From ea9c1002fed3261274eeac0769b165a2f27fcea2 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Fri, 11 Oct 2019 17:51:19 -0600 Subject: [PATCH 001/585] Created placeholders for ComputeGrid and ComputeSNAGrid classes --- src/compute_grid.cpp | 186 ++++++++++++++++++++++++++ src/compute_grid.h | 69 ++++++++++ src/compute_sna_grid.cpp | 277 +++++++++++++++++++++++++++++++++++++++ src/compute_sna_grid.h | 75 +++++++++++ 4 files changed, 607 insertions(+) create mode 100644 src/compute_grid.cpp create mode 100644 src/compute_grid.h create mode 100644 src/compute_sna_grid.cpp create mode 100644 src/compute_sna_grid.h diff --git a/src/compute_grid.cpp b/src/compute_grid.cpp new file mode 100644 index 0000000000..c67d72160b --- /dev/null +++ b/src/compute_grid.cpp @@ -0,0 +1,186 @@ +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#include "compute_grid.h" +#include +#include +#include "atom.h" +#include "update.h" +#include "modify.h" +#include "domain.h" +#include "memory.h" +#include "error.h" + +using namespace LAMMPS_NS; + +enum{ONCE,NFREQ,EVERY}; + +/* ---------------------------------------------------------------------- */ + +ComputeGrid::ComputeGrid(LAMMPS *lmp, int narg, char **arg) : + Compute(lmp, narg, arg), + idchunk(NULL), masstotal(NULL), massproc(NULL), com(NULL), comall(NULL) +{ + if (narg != 4) error->all(FLERR,"Illegal compute com/chunk command"); + + array_flag = 1; + size_array_cols = 3; + size_array_rows = 0; + size_array_rows_variable = 1; + extarray = 0; + + // ID of compute chunk/atom + + int n = strlen(arg[3]) + 1; + idchunk = new char[n]; + strcpy(idchunk,arg[3]); + + init(); + + // chunk-based data + + nchunk = 1; + maxchunk = 0; + allocate(); + + firstflag = massneed = 1; +} + +/* ---------------------------------------------------------------------- */ + +ComputeGrid::~ComputeGrid() +{ + delete [] idchunk; + memory->destroy(massproc); + memory->destroy(masstotal); + memory->destroy(com); + memory->destroy(comall); +} + +/* ---------------------------------------------------------------------- */ + +void ComputeGrid::init() +{ + int icompute = modify->find_compute(idchunk); + if (icompute < 0) + error->all(FLERR,"Chunk/atom compute does not exist for compute com/chunk"); + cchunk = (ComputeChunkAtom *) modify->compute[icompute]; + if (strcmp(cchunk->style,"chunk/atom") != 0) + error->all(FLERR,"Compute com/chunk does not use chunk/atom compute"); +} + +/* ---------------------------------------------------------------------- */ + +void ComputeGrid::setup() +{ + // one-time calculation of per-chunk mass + // done in setup, so that ComputeChunkAtom::setup() is already called + + if (firstflag && cchunk->idsflag == ONCE) { + compute_array(); + firstflag = massneed = 0; + } +} + +/* ---------------------------------------------------------------------- */ + +void ComputeGrid::compute_array() +{ + int index; + double massone; + double unwrap[3]; + + invoked_array = update->ntimestep; + + // compute chunk/atom assigns atoms to chunk IDs + // extract ichunk index vector from compute + // ichunk = 1 to Nchunk for included atoms, 0 for excluded atoms + + nchunk = cchunk->setup_chunks(); + cchunk->compute_ichunk(); + int *ichunk = cchunk->ichunk; + + if (nchunk > maxchunk) allocate(); + size_array_rows = nchunk; + + // zero local per-chunk values + + for (int i = 0; i < nchunk; i++) + com[i][0] = com[i][1] = com[i][2] = 0.0; + if (massneed) + for (int i = 0; i < nchunk; i++) massproc[i] = 0.0; + + // compute COM for each chunk + + double **x = atom->x; + int *mask = atom->mask; + int *type = atom->type; + imageint *image = atom->image; + double *mass = atom->mass; + double *rmass = atom->rmass; + int nlocal = atom->nlocal; + + for (int i = 0; i < nlocal; i++) + if (mask[i] & groupbit) { + index = ichunk[i]-1; + if (index < 0) continue; + if (rmass) massone = rmass[i]; + else massone = mass[type[i]]; + domain->unmap(x[i],image[i],unwrap); + com[index][0] += unwrap[0] * massone; + com[index][1] += unwrap[1] * massone; + com[index][2] += unwrap[2] * massone; + if (massneed) massproc[index] += massone; + } + + MPI_Allreduce(&com[0][0],&comall[0][0],3*nchunk,MPI_DOUBLE,MPI_SUM,world); + if (massneed) + MPI_Allreduce(massproc,masstotal,nchunk,MPI_DOUBLE,MPI_SUM,world); + + for (int i = 0; i < nchunk; i++) { + if (masstotal[i] > 0.0) { + comall[i][0] /= masstotal[i]; + comall[i][1] /= masstotal[i]; + comall[i][2] /= masstotal[i]; + } else comall[i][0] = comall[i][1] = comall[i][2] = 0.0; + } +} + +/* ---------------------------------------------------------------------- + free and reallocate per-chunk arrays +------------------------------------------------------------------------- */ + +void ComputeGrid::allocate() +{ + memory->destroy(massproc); + memory->destroy(masstotal); + memory->destroy(com); + memory->destroy(comall); + maxchunk = nchunk; + memory->create(massproc,maxchunk,"com/chunk:massproc"); + memory->create(masstotal,maxchunk,"com/chunk:masstotal"); + memory->create(com,maxchunk,3,"com/chunk:com"); + memory->create(comall,maxchunk,3,"com/chunk:comall"); + array = comall; +} + +/* ---------------------------------------------------------------------- + memory usage of local data +------------------------------------------------------------------------- */ + +double ComputeGrid::memory_usage() +{ + double bytes = (bigint) maxchunk * 2 * sizeof(double); + bytes += (bigint) maxchunk * 2*3 * sizeof(double); + return bytes; +} diff --git a/src/compute_grid.h b/src/compute_grid.h new file mode 100644 index 0000000000..cece7050de --- /dev/null +++ b/src/compute_grid.h @@ -0,0 +1,69 @@ +/* -*- c++ -*- ---------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#ifdef COMPUTE_CLASS + +ComputeStyle(grid,ComputeGrid) + +#else + +#ifndef LMP_COMPUTE_GRID_H +#define LMP_COMPUTE_GRID_H + +#include "compute.h" + +namespace LAMMPS_NS { + +class ComputeGrid : public Compute { + public: + char *idchunk; // fields accessed by other classes + double *masstotal; + + ComputeGrid(class LAMMPS *, int, char **); + ~ComputeGrid(); + void init(); + void setup(); + void compute_array(); + + void lock_enable(); + void lock_disable(); + int lock_length(); + void lock(class Fix *, bigint, bigint); + void unlock(class Fix *); + + double memory_usage(); + + private: + int nchunk,maxchunk; + int firstflag,massneed; + + double *massproc; + double **com,**comall; + + void allocate(); +}; + +} + +#endif +#endif + +/* ERROR/WARNING messages: + +E: Illegal ... command + +Self-explanatory. Check the input script syntax and compare to the +documentation for the command. You can use -echo screen as a +command-line option when running LAMMPS to see the offending line. + +*/ diff --git a/src/compute_sna_grid.cpp b/src/compute_sna_grid.cpp new file mode 100644 index 0000000000..58f7e9fc38 --- /dev/null +++ b/src/compute_sna_grid.cpp @@ -0,0 +1,277 @@ +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#include "compute_sna_grid.h" +#include +#include +#include "sna.h" +#include "atom.h" +#include "update.h" +#include "modify.h" +#include "neighbor.h" +#include "neigh_list.h" +#include "neigh_request.h" +#include "force.h" +#include "pair.h" +#include "comm.h" +#include "memory.h" +#include "error.h" + +using namespace LAMMPS_NS; + +ComputeSNAGrid::ComputeSNAGrid(LAMMPS *lmp, int narg, char **arg) : + Compute(lmp, narg, arg), cutsq(NULL), list(NULL), sna(NULL), + radelem(NULL), wjelem(NULL) +{ + double rmin0, rfac0; + int twojmax, switchflag, bzeroflag; + radelem = NULL; + wjelem = NULL; + + int ntypes = atom->ntypes; + int nargmin = 6+2*ntypes; + + if (narg < nargmin) error->all(FLERR,"Illegal compute sna/grid command"); + + // default values + + rmin0 = 0.0; + switchflag = 1; + bzeroflag = 1; + quadraticflag = 0; + + // offset by 1 to match up with types + + memory->create(radelem,ntypes+1,"sna/grid:radelem"); + memory->create(wjelem,ntypes+1,"sna/grid:wjelem"); + + rcutfac = atof(arg[3]); + rfac0 = atof(arg[4]); + twojmax = atoi(arg[5]); + + for(int i = 0; i < ntypes; i++) + radelem[i+1] = atof(arg[6+i]); + for(int i = 0; i < ntypes; i++) + wjelem[i+1] = atof(arg[6+ntypes+i]); + + // construct cutsq + + double cut; + cutmax = 0.0; + memory->create(cutsq,ntypes+1,ntypes+1,"sna/grid:cutsq"); + for(int i = 1; i <= ntypes; i++) { + cut = 2.0*radelem[i]*rcutfac; + if (cut > cutmax) cutmax = cut; + cutsq[i][i] = cut*cut; + for(int j = i+1; j <= ntypes; j++) { + cut = (radelem[i]+radelem[j])*rcutfac; + cutsq[i][j] = cutsq[j][i] = cut*cut; + } + } + + // process optional args + + int iarg = nargmin; + + while (iarg < narg) { + if (strcmp(arg[iarg],"rmin0") == 0) { + if (iarg+2 > narg) + error->all(FLERR,"Illegal compute sna/grid command"); + rmin0 = atof(arg[iarg+1]); + iarg += 2; + } else if (strcmp(arg[iarg],"switchflag") == 0) { + if (iarg+2 > narg) + error->all(FLERR,"Illegal compute sna/grid command"); + switchflag = atoi(arg[iarg+1]); + iarg += 2; + } else if (strcmp(arg[iarg],"bzeroflag") == 0) { + if (iarg+2 > narg) + error->all(FLERR,"Illegal compute sna/grid command"); + bzeroflag = atoi(arg[iarg+1]); + iarg += 2; + } else if (strcmp(arg[iarg],"quadraticflag") == 0) { + if (iarg+2 > narg) + error->all(FLERR,"Illegal compute sna/grid command"); + quadraticflag = atoi(arg[iarg+1]); + iarg += 2; + } else error->all(FLERR,"Illegal compute sna/grid command"); + } + + snaptr = new SNA(lmp,rfac0,twojmax, + rmin0,switchflag,bzeroflag); + + ncoeff = snaptr->ncoeff; + size_peratom_cols = ncoeff; + if (quadraticflag) size_peratom_cols += (ncoeff*(ncoeff+1))/2; + peratom_flag = 1; + + nmax = 0; + sna = NULL; +} + +/* ---------------------------------------------------------------------- */ + +ComputeSNAGrid::~ComputeSNAGrid() +{ + memory->destroy(sna); + memory->destroy(radelem); + memory->destroy(wjelem); + memory->destroy(cutsq); + delete snaptr; +} + +/* ---------------------------------------------------------------------- */ + +void ComputeSNAGrid::init() +{ + if (force->pair == NULL) + error->all(FLERR,"Compute sna/grid requires a pair style be defined"); + + if (cutmax > force->pair->cutforce) + error->all(FLERR,"Compute sna/grid cutoff is longer than pairwise cutoff"); + + // need an occasional full neighbor list + + int irequest = neighbor->request(this,instance_me); + neighbor->requests[irequest]->pair = 0; + neighbor->requests[irequest]->compute = 1; + neighbor->requests[irequest]->half = 0; + neighbor->requests[irequest]->full = 1; + neighbor->requests[irequest]->occasional = 1; + + int count = 0; + for (int i = 0; i < modify->ncompute; i++) + if (strcmp(modify->compute[i]->style,"sna/grid") == 0) count++; + if (count > 1 && comm->me == 0) + error->warning(FLERR,"More than one compute sna/grid"); + snaptr->init(); +} + +/* ---------------------------------------------------------------------- */ + +void ComputeSNAGrid::init_list(int /*id*/, NeighList *ptr) +{ + list = ptr; +} + +/* ---------------------------------------------------------------------- */ + +void ComputeSNAGrid::compute_pergrid() +{ + invoked_peratom = update->ntimestep; + + // grow sna array if necessary + + if (atom->nmax > nmax) { + memory->destroy(sna); + nmax = atom->nmax; + memory->create(sna,nmax,size_peratom_cols,"sna/grid:sna"); + array_atom = sna; + } + + // invoke full neighbor list (will copy or build if necessary) + + neighbor->build_one(list); + + const int inum = list->inum; + const int* const ilist = list->ilist; + const int* const numneigh = list->numneigh; + int** const firstneigh = list->firstneigh; + int * const type = atom->type; + + // compute sna for each atom in group + // use full neighbor list to count atoms less than cutoff + + double** const x = atom->x; + const int* const mask = atom->mask; + + for (int ii = 0; ii < inum; ii++) { + const int i = ilist[ii]; + if (mask[i] & groupbit) { + + const double xtmp = x[i][0]; + const double ytmp = x[i][1]; + const double ztmp = x[i][2]; + const int itype = type[i]; + const double radi = radelem[itype]; + const int* const jlist = firstneigh[i]; + const int jnum = numneigh[i]; + + // insure rij, inside, and typej are of size jnum + + snaptr->grow_rij(jnum); + + // rij[][3] = displacements between atom I and those neighbors + // inside = indices of neighbors of I within cutoff + // typej = types of neighbors of I within cutoff + + int ninside = 0; + for (int jj = 0; jj < jnum; jj++) { + int j = jlist[jj]; + j &= NEIGHMASK; + + const double delx = xtmp - x[j][0]; + const double dely = ytmp - x[j][1]; + const double delz = ztmp - x[j][2]; + const double rsq = delx*delx + dely*dely + delz*delz; + int jtype = type[j]; + if (rsq < cutsq[itype][jtype] && rsq>1e-20) { + snaptr->rij[ninside][0] = delx; + snaptr->rij[ninside][1] = dely; + snaptr->rij[ninside][2] = delz; + snaptr->inside[ninside] = j; + snaptr->wj[ninside] = wjelem[jtype]; + snaptr->rcutij[ninside] = (radi+radelem[jtype])*rcutfac; + ninside++; + } + } + + snaptr->compute_ui(ninside); + snaptr->compute_zi(); + snaptr->compute_bi(); + for (int icoeff = 0; icoeff < ncoeff; icoeff++) + sna[i][icoeff] = snaptr->blist[icoeff]; + if (quadraticflag) { + int ncount = ncoeff; + for (int icoeff = 0; icoeff < ncoeff; icoeff++) { + double bi = snaptr->blist[icoeff]; + + // diagonal element of quadratic matrix + + sna[i][ncount++] = 0.5*bi*bi; + + // upper-triangular elements of quadratic matrix + + for (int jcoeff = icoeff+1; jcoeff < ncoeff; jcoeff++) + sna[i][ncount++] = bi*snaptr->blist[jcoeff]; + } + } + } else { + for (int icoeff = 0; icoeff < size_peratom_cols; icoeff++) + sna[i][icoeff] = 0.0; + } + } +} + +/* ---------------------------------------------------------------------- + memory usage +------------------------------------------------------------------------- */ + +double ComputeSNAGrid::memory_usage() +{ + double bytes = nmax*size_peratom_cols * sizeof(double); // sna + bytes += snaptr->memory_usage(); // SNA object + + return bytes; +} + diff --git a/src/compute_sna_grid.h b/src/compute_sna_grid.h new file mode 100644 index 0000000000..f85d9679cc --- /dev/null +++ b/src/compute_sna_grid.h @@ -0,0 +1,75 @@ +/* -*- c++ -*- ---------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#ifdef COMPUTE_CLASS + +ComputeStyle(sna/grid,ComputeSNAGrid) + +#else + +#ifndef LMP_COMPUTE_SNA_GRID_H +#define LMP_COMPUTE_SNA_GRID_H + +#include "compute.h" + +namespace LAMMPS_NS { + +class ComputeSNAGrid : public Compute { + public: + ComputeSNAGrid(class LAMMPS *, int, char **); + ~ComputeSNAGrid(); + void init(); + void init_list(int, class NeighList *); + void compute_grid(); + double memory_usage(); + + private: + int nmax; + int ncoeff; + double **cutsq; + class NeighList *list; + double **sna; + double rcutfac; + double *radelem; + double *wjelem; + class SNA* snaptr; + double cutmax; + int quadraticflag; +}; + +} + +#endif +#endif + +/* ERROR/WARNING messages: + +E: Illegal ... command + +Self-explanatory. Check the input script syntax and compare to the +documentation for the command. You can use -echo screen as a +command-line option when running LAMMPS to see the offending line. + +E: Compute sna/grid requires a pair style be defined + +Self-explanatory. + +E: Compute sna/grid cutoff is longer than pairwise cutoff + +Self-explanatory. + +W: More than one compute sna/grid + +Self-explanatory. + +*/ From 762ecf8f0e5bb8fb146bb7ef42bd80e9a4e7f9e1 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Sat, 19 Oct 2019 17:03:19 -0600 Subject: [PATCH 002/585] Completed serial version with PBC, but incorrect --- src/compute_grid.cpp | 255 +++++++++++++++++++++++---------------- src/compute_grid.h | 45 ++++--- src/compute_sna_grid.cpp | 166 +++++++++++++------------ src/compute_sna_grid.h | 8 +- 4 files changed, 266 insertions(+), 208 deletions(-) diff --git a/src/compute_grid.cpp b/src/compute_grid.cpp index c67d72160b..d8c7eb3697 100644 --- a/src/compute_grid.cpp +++ b/src/compute_grid.cpp @@ -18,169 +18,218 @@ #include "update.h" #include "modify.h" #include "domain.h" +#include "force.h" #include "memory.h" #include "error.h" using namespace LAMMPS_NS; -enum{ONCE,NFREQ,EVERY}; - /* ---------------------------------------------------------------------- */ ComputeGrid::ComputeGrid(LAMMPS *lmp, int narg, char **arg) : - Compute(lmp, narg, arg), - idchunk(NULL), masstotal(NULL), massproc(NULL), com(NULL), comall(NULL) + Compute(lmp, narg, arg) { - if (narg != 4) error->all(FLERR,"Illegal compute com/chunk command"); + if (narg < 6) error->all(FLERR,"Illegal compute grid command"); array_flag = 1; - size_array_cols = 3; + size_array_cols = 0; size_array_rows = 0; - size_array_rows_variable = 1; - extarray = 0; + extarray = 1; - // ID of compute chunk/atom + int iarg0 = 3; + int iarg = iarg0; + if (strcmp(arg[iarg],"grid") == 0) { + if (iarg+4 > narg) error->all(FLERR,"Illegal compute grid command"); + nx = force->inumeric(FLERR,arg[iarg+1]); + ny = force->inumeric(FLERR,arg[iarg+2]); + nz = force->inumeric(FLERR,arg[iarg+3]); + if (nx <= 0 || ny <= 0 || nz <= 0) + error->all(FLERR,"All grid dimensions must be positive"); + iarg += 4; + } else error->all(FLERR,"Illegal compute grid command"); - int n = strlen(arg[3]) + 1; - idchunk = new char[n]; - strcpy(idchunk,arg[3]); + nargbase = iarg - iarg0; - init(); - - // chunk-based data - - nchunk = 1; - maxchunk = 0; - allocate(); - - firstflag = massneed = 1; + size_array_rows = nx*ny*nz; } /* ---------------------------------------------------------------------- */ ComputeGrid::~ComputeGrid() { - delete [] idchunk; - memory->destroy(massproc); - memory->destroy(masstotal); - memory->destroy(com); - memory->destroy(comall); } /* ---------------------------------------------------------------------- */ void ComputeGrid::init() { - int icompute = modify->find_compute(idchunk); - if (icompute < 0) - error->all(FLERR,"Chunk/atom compute does not exist for compute com/chunk"); - cchunk = (ComputeChunkAtom *) modify->compute[icompute]; - if (strcmp(cchunk->style,"chunk/atom") != 0) - error->all(FLERR,"Compute com/chunk does not use chunk/atom compute"); } /* ---------------------------------------------------------------------- */ void ComputeGrid::setup() { - // one-time calculation of per-chunk mass - // done in setup, so that ComputeChunkAtom::setup() is already called + + // calculate grid layout - if (firstflag && cchunk->idsflag == ONCE) { - compute_array(); - firstflag = massneed = 0; + triclinic = domain->triclinic; + + if (triclinic == 0) { + prd = domain->prd; + boxlo = domain->boxlo; + } else { + prd = domain->prd_lamda; + boxlo = domain->boxlo_lamda; } + + double xprd = prd[0]; + double yprd = prd[1]; + double zprd = prd[2]; + + delxinv = nx/xprd; + delyinv = ny/yprd; + delzinv = nz/zprd; + + delx = 1.0/delxinv; + dely = 1.0/delyinv; + delz = 1.0/delzinv; + + // sufficient conditions for stencil bounding rcut + + // require |delz*mz|^2 <= rcut^2 + // require |dely*my|^2 <= rcut^2 + |delyz*mz_max|^2 + // require |delx*mx|^2 <= rcut^2 + |delxz*mz_max|^2 + |delxy*my_max|^2 + + double delxy = domain->xy/ny; + double delxz = domain->xz/nz; + double delyz = domain->yz/nz; + + if (!triclinic) { + mz = cutmax*delzinv + 1; + my = sqrt(cutmax*cutmax + pow(delyz*mz,2))*delyinv + 1; + mx = sqrt(cutmax*cutmax + pow(delxz*mz,2) + + pow(delxy*my,2))*delxinv + 1; + } else { + double delxinvtmp = nx/domain->xprd; + double delyinvtmp = ny/domain->yprd; + double delzinvtmp = nz/domain->zprd; + mz = cutmax*delzinvtmp + 1; + my = sqrt(cutmax*cutmax + pow(delyz*mz,2))*delyinvtmp + 1; + mx = sqrt(cutmax*cutmax + pow(delxz*mz,2) + + pow(delxy*my,2))*delxinvtmp + 1; + } + + printf("mx = %d\n",mx); + printf("my = %d\n",my); + printf("mz = %d\n",mz); + + // size global grid to accomodate periodic interactions + + nxfull = nx + 2*mx; + nyfull = ny + 2*my; + nzfull = nz + 2*mz; + nxyfull = nxfull * nyfull; + + printf("nxfull = %d\n",nxfull); + printf("nyfull = %d\n",nyfull); + printf("nzfull = %d\n",nzfull); + + x0full = boxlo[0] - mx*delx; + y0full = boxlo[1] - my*dely; + z0full = boxlo[2] - mz*delz; + + allocate(); } -/* ---------------------------------------------------------------------- */ +/* ---------------------------------------------------------------------- + convert grid index to box coords +------------------------------------------------------------------------- */ -void ComputeGrid::compute_array() +void ComputeGrid::igridfull2x(int igrid, double *x) { - int index; - double massone; - double unwrap[3]; + int iz = igrid / nxyfull; + igrid -= iz*nxyfull; + int iy = igrid / nxfull; + igrid -= igrid*nxfull; + int ix = igrid; - invoked_array = update->ntimestep; + x[0] = x0full+ix*delx; + x[1] = y0full+iy*dely; + x[2] = z0full+iz*delz; - // compute chunk/atom assigns atoms to chunk IDs - // extract ichunk index vector from compute - // ichunk = 1 to Nchunk for included atoms, 0 for excluded atoms + if (triclinic) domain->lamda2x(x, x); - nchunk = cchunk->setup_chunks(); - cchunk->compute_ichunk(); - int *ichunk = cchunk->ichunk; +} - if (nchunk > maxchunk) allocate(); - size_array_rows = nchunk; +/* ---------------------------------------------------------------------- + gather global array from full grid +------------------------------------------------------------------------- */ - // zero local per-chunk values +void ComputeGrid::gather_global_array() +{ + int iarray; + memset(&array[0][0],0,size_array_rows*size_array_cols*sizeof(double)); - for (int i = 0; i < nchunk; i++) - com[i][0] = com[i][1] = com[i][2] = 0.0; - if (massneed) - for (int i = 0; i < nchunk; i++) massproc[i] = 0.0; + for (int igrid = 0; igrid < ngridfull; igrid++) { - // compute COM for each chunk + // inefficient, should exploit shared ix structure - double **x = atom->x; - int *mask = atom->mask; - int *type = atom->type; - imageint *image = atom->image; - double *mass = atom->mass; - double *rmass = atom->rmass; - int nlocal = atom->nlocal; - - for (int i = 0; i < nlocal; i++) - if (mask[i] & groupbit) { - index = ichunk[i]-1; - if (index < 0) continue; - if (rmass) massone = rmass[i]; - else massone = mass[type[i]]; - domain->unmap(x[i],image[i],unwrap); - com[index][0] += unwrap[0] * massone; - com[index][1] += unwrap[1] * massone; - com[index][2] += unwrap[2] * massone; - if (massneed) massproc[index] += massone; - } - - MPI_Allreduce(&com[0][0],&comall[0][0],3*nchunk,MPI_DOUBLE,MPI_SUM,world); - if (massneed) - MPI_Allreduce(massproc,masstotal,nchunk,MPI_DOUBLE,MPI_SUM,world); - - for (int i = 0; i < nchunk; i++) { - if (masstotal[i] > 0.0) { - comall[i][0] /= masstotal[i]; - comall[i][1] /= masstotal[i]; - comall[i][2] /= masstotal[i]; - } else comall[i][0] = comall[i][1] = comall[i][2] = 0.0; + iarray = igridfull2iarray(igrid); + for (int icol = 0; icol < size_array_cols; icol++) + array[iarray][icol] += gridfull[igrid][icol]; } } /* ---------------------------------------------------------------------- - free and reallocate per-chunk arrays + convert full grid index to compute array index + inefficient, should exploit shared ix structure +------------------------------------------------------------------------- */ + +int ComputeGrid::igridfull2iarray(int igrid) +{ + int iz = igrid / nxyfull; + igrid -= iz*nxyfull; + int iy = igrid / nxfull; + igrid -= igrid*nxfull; + int ix = igrid; + + ix -= mx; + iy -= my; + iz -= mz; + + while (ix < 0) ix += nx; + while (iy < 0) iy += ny; + while (iz < 0) iz += nz; + + while (ix >= nx) ix -= nx; + while (iy >= ny) iy -= ny; + while (iz >= nz) iz -= nz; + + int iarray = (iz * ny + iy) * nx + ix; + + return iarray; +} + +/* ---------------------------------------------------------------------- + free and reallocate arrays ------------------------------------------------------------------------- */ void ComputeGrid::allocate() { - memory->destroy(massproc); - memory->destroy(masstotal); - memory->destroy(com); - memory->destroy(comall); - maxchunk = nchunk; - memory->create(massproc,maxchunk,"com/chunk:massproc"); - memory->create(masstotal,maxchunk,"com/chunk:masstotal"); - memory->create(com,maxchunk,3,"com/chunk:com"); - memory->create(comall,maxchunk,3,"com/chunk:comall"); - array = comall; -} + ngridfull = nxfull*nyfull*nzfull; + // grow global array if necessary + + memory->destroy(array); + memory->create(array,size_array_rows,size_array_cols,"sna/grid:array"); + memory->create(gridfull,ngridfull,size_array_cols,"sna/grid:gridfull"); +} /* ---------------------------------------------------------------------- memory usage of local data ------------------------------------------------------------------------- */ double ComputeGrid::memory_usage() { - double bytes = (bigint) maxchunk * 2 * sizeof(double); - bytes += (bigint) maxchunk * 2*3 * sizeof(double); - return bytes; + int nbytes = 0; + return nbytes; } diff --git a/src/compute_grid.h b/src/compute_grid.h index cece7050de..61775186ff 100644 --- a/src/compute_grid.h +++ b/src/compute_grid.h @@ -11,12 +11,6 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#ifdef COMPUTE_CLASS - -ComputeStyle(grid,ComputeGrid) - -#else - #ifndef LMP_COMPUTE_GRID_H #define LMP_COMPUTE_GRID_H @@ -26,36 +20,39 @@ namespace LAMMPS_NS { class ComputeGrid : public Compute { public: - char *idchunk; // fields accessed by other classes - double *masstotal; ComputeGrid(class LAMMPS *, int, char **); - ~ComputeGrid(); + virtual ~ComputeGrid(); void init(); void setup(); - void compute_array(); - - void lock_enable(); - void lock_disable(); - int lock_length(); - void lock(class Fix *, bigint, bigint); - void unlock(class Fix *); + virtual void compute_array() = 0; double memory_usage(); + protected: + int nx, ny, nz; // grid dimensions + int nxfull, nyfull, nzfull; // grid dimensions with ghost points + int nxyfull; // nx_full*ny_full + int ngridfull; // number of full grid points + double **gridfull; // full grid points + int mx, my, mz; // cutmax stencil dimensions + int triclinic; // triclinic flag + double *boxlo, *prd; // box info (units real/ortho or reduced/tri) + double delxinv,delyinv,delzinv; // inverse grid spacing + double delx,dely,delz; // grid spacing + double x0full, y0full, z0full; // origin of full grid + int nargbase; // number of base class args + double cutmax; // largest cutoff distance + virtual void allocate(); + void igridfull2x(int, double*); // convert full grid point to coord + void gather_global_array(); // gather global array from full grid + int igridfull2iarray(int); // convert full grid index to compute array index + private: - int nchunk,maxchunk; - int firstflag,massneed; - - double *massproc; - double **com,**comall; - - void allocate(); }; } -#endif #endif /* ERROR/WARNING messages: diff --git a/src/compute_sna_grid.cpp b/src/compute_sna_grid.cpp index 58f7e9fc38..1f998ced9b 100644 --- a/src/compute_sna_grid.cpp +++ b/src/compute_sna_grid.cpp @@ -11,6 +11,7 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +#include "compute_grid.h" #include "compute_sna_grid.h" #include #include @@ -30,7 +31,7 @@ using namespace LAMMPS_NS; ComputeSNAGrid::ComputeSNAGrid(LAMMPS *lmp, int narg, char **arg) : - Compute(lmp, narg, arg), cutsq(NULL), list(NULL), sna(NULL), + ComputeGrid(lmp, narg, arg), cutsq(NULL), list(NULL), sna(NULL), radelem(NULL), wjelem(NULL) { double rmin0, rfac0; @@ -38,6 +39,13 @@ ComputeSNAGrid::ComputeSNAGrid(LAMMPS *lmp, int narg, char **arg) : radelem = NULL; wjelem = NULL; + // skip over arguments used by base class + // so that argument positions are identical to + // regular per-atom compute + + arg += nargbase; + narg -= nargbase; + int ntypes = atom->ntypes; int nargmin = 6+2*ntypes; @@ -58,6 +66,7 @@ ComputeSNAGrid::ComputeSNAGrid(LAMMPS *lmp, int narg, char **arg) : rcutfac = atof(arg[3]); rfac0 = atof(arg[4]); twojmax = atoi(arg[5]); + printf("rcutfac = %g rfac0 = %g twojmax = %d\n",rcutfac, rfac0, twojmax); for(int i = 0; i < ntypes; i++) radelem[i+1] = atof(arg[6+i]); @@ -73,6 +82,7 @@ ComputeSNAGrid::ComputeSNAGrid(LAMMPS *lmp, int narg, char **arg) : cut = 2.0*radelem[i]*rcutfac; if (cut > cutmax) cutmax = cut; cutsq[i][i] = cut*cut; + printf("i = %d cutsq[i][i] = %g\n",i,cutsq[i][i]); for(int j = i+1; j <= ntypes; j++) { cut = (radelem[i]+radelem[j])*rcutfac; cutsq[i][j] = cutsq[j][i] = cut*cut; @@ -84,6 +94,7 @@ ComputeSNAGrid::ComputeSNAGrid(LAMMPS *lmp, int narg, char **arg) : int iarg = nargmin; while (iarg < narg) { + printf("iarg = %d arg = %s\n",iarg, arg[iarg]); if (strcmp(arg[iarg],"rmin0") == 0) { if (iarg+2 > narg) error->all(FLERR,"Illegal compute sna/grid command"); @@ -105,18 +116,19 @@ ComputeSNAGrid::ComputeSNAGrid(LAMMPS *lmp, int narg, char **arg) : quadraticflag = atoi(arg[iarg+1]); iarg += 2; } else error->all(FLERR,"Illegal compute sna/grid command"); + } + printf("rmin0 = %g, bzeroflag = %d, quadraticflag = %d\n", + rmin0, bzeroflag, quadraticflag); + snaptr = new SNA(lmp,rfac0,twojmax, rmin0,switchflag,bzeroflag); ncoeff = snaptr->ncoeff; - size_peratom_cols = ncoeff; - if (quadraticflag) size_peratom_cols += (ncoeff*(ncoeff+1))/2; - peratom_flag = 1; - - nmax = 0; - sna = NULL; + size_array_cols = ncoeff; + if (quadraticflag) size_array_cols += (ncoeff*(ncoeff+1))/2; + array_flag = 1; } /* ---------------------------------------------------------------------- */ @@ -166,101 +178,101 @@ void ComputeSNAGrid::init_list(int /*id*/, NeighList *ptr) /* ---------------------------------------------------------------------- */ -void ComputeSNAGrid::compute_pergrid() +void ComputeSNAGrid::compute_array() { - invoked_peratom = update->ntimestep; + invoked_array = update->ntimestep; - // grow sna array if necessary +// // invoke full neighbor list (will copy or build if necessary) - if (atom->nmax > nmax) { - memory->destroy(sna); - nmax = atom->nmax; - memory->create(sna,nmax,size_peratom_cols,"sna/grid:sna"); - array_atom = sna; - } +// neighbor->build_one(list); - // invoke full neighbor list (will copy or build if necessary) +// const int inum = list->inum; +// const int* const ilist = list->ilist; +// const int* const numneigh = list->numneigh; +// int** const firstneigh = list->firstneigh; - neighbor->build_one(list); - - const int inum = list->inum; - const int* const ilist = list->ilist; - const int* const numneigh = list->numneigh; - int** const firstneigh = list->firstneigh; int * const type = atom->type; - // compute sna for each atom in group - // use full neighbor list to count atoms less than cutoff + // compute sna for each gridpoint double** const x = atom->x; const int* const mask = atom->mask; + const int ntotal = atom->nlocal + atom->nghost; - for (int ii = 0; ii < inum; ii++) { - const int i = ilist[ii]; - if (mask[i] & groupbit) { + printf("ngridfull = %d\n",ngridfull); + for (int igrid = 0; igrid < ngridfull; igrid++) { + printf("igrid = %d\n",igrid); + double rtmp[3]; + igridfull2x(igrid, rtmp); + const double xtmp = rtmp[0]; + const double ytmp = rtmp[1]; + const double ztmp = rtmp[2]; - const double xtmp = x[i][0]; - const double ytmp = x[i][1]; - const double ztmp = x[i][2]; - const int itype = type[i]; - const double radi = radelem[itype]; - const int* const jlist = firstneigh[i]; - const int jnum = numneigh[i]; + // rij[][3] = displacements between atom I and those neighbors + // inside = indices of neighbors of I within cutoff + // typej = types of neighbors of I within cutoff - // insure rij, inside, and typej are of size jnum + int ninside = 0; + for (int j = 0; j < ntotal; j++) { - snaptr->grow_rij(jnum); + // check that j is in comute group - // rij[][3] = displacements between atom I and those neighbors - // inside = indices of neighbors of I within cutoff - // typej = types of neighbors of I within cutoff + if (!(mask[j] & groupbit)) continue; - int ninside = 0; - for (int jj = 0; jj < jnum; jj++) { - int j = jlist[jj]; - j &= NEIGHMASK; + // insure rij, inside, and typej are of size jnum - const double delx = xtmp - x[j][0]; - const double dely = ytmp - x[j][1]; - const double delz = ztmp - x[j][2]; - const double rsq = delx*delx + dely*dely + delz*delz; - int jtype = type[j]; - if (rsq < cutsq[itype][jtype] && rsq>1e-20) { - snaptr->rij[ninside][0] = delx; - snaptr->rij[ninside][1] = dely; - snaptr->rij[ninside][2] = delz; - snaptr->inside[ninside] = j; - snaptr->wj[ninside] = wjelem[jtype]; - snaptr->rcutij[ninside] = (radi+radelem[jtype])*rcutfac; - ninside++; - } + snaptr->grow_rij(ninside+1); + + const double delx = xtmp - x[j][0]; + const double dely = ytmp - x[j][1]; + const double delz = ztmp - x[j][2]; + const double rsq = delx*delx + dely*dely + delz*delz; + int jtype = type[j]; + if (rsq < cutsq[jtype][jtype] && rsq>1e-20) { + printf("ninside = %d\n",ninside); + snaptr->rij[ninside][0] = delx; + snaptr->rij[ninside][1] = dely; + snaptr->rij[ninside][2] = delz; + snaptr->inside[ninside] = j; + snaptr->wj[ninside] = wjelem[jtype]; + snaptr->rcutij[ninside] = 2.0*radelem[jtype]*rcutfac; + ninside++; } + } - snaptr->compute_ui(ninside); - snaptr->compute_zi(); - snaptr->compute_bi(); - for (int icoeff = 0; icoeff < ncoeff; icoeff++) - sna[i][icoeff] = snaptr->blist[icoeff]; - if (quadraticflag) { - int ncount = ncoeff; - for (int icoeff = 0; icoeff < ncoeff; icoeff++) { - double bi = snaptr->blist[icoeff]; + snaptr->compute_ui(ninside); + snaptr->compute_zi(); + snaptr->compute_bi(); + for (int icoeff = 0; icoeff < ncoeff; icoeff++) + sna[igrid][icoeff] = snaptr->blist[icoeff]; + printf("igrid = %d B0 = %g\n",igrid,sna[igrid][0]); + if (quadraticflag) { + int ncount = ncoeff; + for (int icoeff = 0; icoeff < ncoeff; icoeff++) { + double bi = snaptr->blist[icoeff]; - // diagonal element of quadratic matrix + // diagonal element of quadratic matrix - sna[i][ncount++] = 0.5*bi*bi; + sna[igrid][ncount++] = 0.5*bi*bi; - // upper-triangular elements of quadratic matrix + // upper-triangular elements of quadratic matrix - for (int jcoeff = icoeff+1; jcoeff < ncoeff; jcoeff++) - sna[i][ncount++] = bi*snaptr->blist[jcoeff]; - } + for (int jcoeff = icoeff+1; jcoeff < ncoeff; jcoeff++) + sna[igrid][ncount++] = bi*snaptr->blist[jcoeff]; } - } else { - for (int icoeff = 0; icoeff < size_peratom_cols; icoeff++) - sna[i][icoeff] = 0.0; } } + gather_global_array(); +} + +/* ---------------------------------------------------------------------- + allocate array in base class and then set up pointers +------------------------------------------------------------------------- */ + +void ComputeSNAGrid::allocate() +{ + ComputeGrid::allocate(); + sna = gridfull; } /* ---------------------------------------------------------------------- @@ -269,7 +281,7 @@ void ComputeSNAGrid::compute_pergrid() double ComputeSNAGrid::memory_usage() { - double bytes = nmax*size_peratom_cols * sizeof(double); // sna + double bytes = size_array_rows*size_array_cols * sizeof(double); // grid bytes += snaptr->memory_usage(); // SNA object return bytes; diff --git a/src/compute_sna_grid.h b/src/compute_sna_grid.h index f85d9679cc..2bd18a915e 100644 --- a/src/compute_sna_grid.h +++ b/src/compute_sna_grid.h @@ -20,18 +20,19 @@ ComputeStyle(sna/grid,ComputeSNAGrid) #ifndef LMP_COMPUTE_SNA_GRID_H #define LMP_COMPUTE_SNA_GRID_H -#include "compute.h" +#include "compute_grid.h" namespace LAMMPS_NS { -class ComputeSNAGrid : public Compute { +class ComputeSNAGrid : public ComputeGrid { public: ComputeSNAGrid(class LAMMPS *, int, char **); ~ComputeSNAGrid(); void init(); void init_list(int, class NeighList *); - void compute_grid(); + void compute_array(); double memory_usage(); + void allocate(); private: int nmax; @@ -43,7 +44,6 @@ class ComputeSNAGrid : public Compute { double *radelem; double *wjelem; class SNA* snaptr; - double cutmax; int quadraticflag; }; From 8374280383487f86c1f69f437501e1a77c253e60 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Wed, 23 Oct 2019 18:46:28 -0600 Subject: [PATCH 003/585] Got a first pass working for ortho and tri grids --- examples/snap/in.grid | 71 +++++++++++++++++ examples/snap/in.grid.tri | 116 ++++++++++++++++++++++++++++ src/{ => SNAP}/compute_sna_grid.cpp | 0 src/{ => SNAP}/compute_sna_grid.h | 0 src/compute_grid.cpp | 56 ++++++++++---- src/compute_grid.h | 2 + 6 files changed, 231 insertions(+), 14 deletions(-) create mode 100644 examples/snap/in.grid create mode 100644 examples/snap/in.grid.tri rename src/{ => SNAP}/compute_sna_grid.cpp (100%) rename src/{ => SNAP}/compute_sna_grid.h (100%) diff --git a/examples/snap/in.grid b/examples/snap/in.grid new file mode 100644 index 0000000000..bec57dc9ff --- /dev/null +++ b/examples/snap/in.grid @@ -0,0 +1,71 @@ +# Demonstrate bispectrum computes + +# Initialize simulation + +variable nsteps index 0 +variable nrep index 1 +variable a index 3.316 +variable ngrid index 2 + +units metal + +# generate the box and atom positions using a BCC lattice + +variable nx equal ${nrep} +variable ny equal ${nrep} +variable nz equal ${nrep} + +boundary p p p + +lattice custom $a & + a1 1 0 0 & + a2 0 1 0 & + a3 0 0 1 & + basis 0 0 0 & + basis 0.5 0.5 0.5 & +# origin 0.25 0.25 0.25 + +region box block 0 ${nx} 0 ${ny} 0 ${nz} +create_box 1 box +create_atoms 1 box + +mass 1 180.88 + +# choose potential + +include Ta06A.snap + +# define grid compute and atom compute + +group snapgroup type 1 +variable twojmax equal 2 +variable rcutfac equal 4.67637 +variable rfac0 equal 0.99363 +variable rmin0 equal 0 +variable wj equal 1 +variable radelem equal 0.5 +variable bzero equal 0 +variable quad equal 0 +variable switch equal 0 + +compute b all sna/atom & + ${rcutfac} ${rfac0} ${twojmax} ${radelem} & + ${wj} rmin0 ${rmin0} bzeroflag ${bzero} & + quadraticflag ${quad} switchflag ${switch} + +compute mygrid all sna/grid grid ${ngrid} ${ngrid} ${ngrid} & + ${rcutfac} ${rfac0} ${twojmax} ${radelem} & + ${wj} rmin0 ${rmin0} bzeroflag ${bzero} & + quadraticflag ${quad} switchflag ${switch} + +# define output + +thermo_style custom step temp ke pe vol c_mygrid[1][1] c_mygrid[2][1] c_mygrid[3][1] c_mygrid[4][1] c_mygrid[5][1] c_mygrid[6][1] c_mygrid[7][1] c_mygrid[8][1] +thermo_modify norm yes + +dump mydump_b all custom 1000 dump_b id c_b[*] + +# run + +run 0 + diff --git a/examples/snap/in.grid.tri b/examples/snap/in.grid.tri new file mode 100644 index 0000000000..c02138f66a --- /dev/null +++ b/examples/snap/in.grid.tri @@ -0,0 +1,116 @@ +# Demonstrate bispectrum computes + +# Initialize simulation + +variable nsteps index 0 +variable nrep index 1 +variable a index 3.316 +variable ngrid index 4 + +variable ngridx equal 3*${ngrid} +variable ngridy equal 2*${ngrid} +variable ngridz equal 1*${ngrid} + +units metal + +# generate the box and atom positions using a BCC lattice + +variable nx equal ${nrep} +variable ny equal ${nrep} +variable nz equal ${nrep} + +boundary p p p + +lattice custom $a & + a1 1 0 0 & + a2 1 1 0 & + a3 1 1 1 & + basis 0 0 0 & + basis 0.0 0.0 0.5 & +# origin 0.25 0.25 0.25 + +box tilt large +region box prism 0 ${nx} 0 ${ny} 0 ${nz} ${ny} ${nz} ${nz} +create_box 1 box +create_atoms 1 box + +mass 1 180.88 + +# choose potential + +include Ta06A.snap + +# define grid compute and atom compute + +group snapgroup type 1 +variable twojmax equal 2 +variable rcutfac equal 4.67637 +variable rfac0 equal 0.99363 +variable rmin0 equal 0 +variable wj equal 1 +variable radelem equal 0.5 +variable bzero equal 0 +variable quad equal 0 +variable switch equal 0 + +compute b all sna/atom & + ${rcutfac} ${rfac0} ${twojmax} ${radelem} & + ${wj} rmin0 ${rmin0} bzeroflag ${bzero} & + quadraticflag ${quad} switchflag ${switch} + +compute mygrid all sna/grid grid ${ngridx} ${ngridy} ${ngridz} & + ${rcutfac} ${rfac0} ${twojmax} ${radelem} & + ${wj} rmin0 ${rmin0} bzeroflag ${bzero} & + quadraticflag ${quad} switchflag ${switch} + +# define output + +thermo_style custom step temp ke pe vol & + c_mygrid[1][1] c_mygrid[2][1] c_mygrid[3][1] c_mygrid[4][1] c_mygrid[5][1] c_mygrid[6][1] c_mygrid[7][1] c_mygrid[8][1] c_mygrid[9][1] & + c_mygrid[10][1] c_mygrid[11][1] c_mygrid[12][1] c_mygrid[13][1] c_mygrid[14][1] c_mygrid[15][1] c_mygrid[16][1] c_mygrid[17][1] c_mygrid[18][1] c_mygrid[19][1] & + c_mygrid[20][1] c_mygrid[21][1] c_mygrid[22][1] c_mygrid[23][1] c_mygrid[24][1] c_mygrid[25][1] c_mygrid[26][1] c_mygrid[27][1] c_mygrid[28][1] c_mygrid[29][1] & + c_mygrid[30][1] c_mygrid[31][1] c_mygrid[32][1] c_mygrid[33][1] c_mygrid[34][1] c_mygrid[35][1] c_mygrid[36][1] c_mygrid[37][1] c_mygrid[38][1] c_mygrid[39][1] & + c_mygrid[40][1] c_mygrid[41][1] c_mygrid[42][1] c_mygrid[43][1] c_mygrid[44][1] c_mygrid[45][1] c_mygrid[46][1] c_mygrid[47][1] c_mygrid[48][1] c_mygrid[49][1] & + c_mygrid[50][1] c_mygrid[51][1] c_mygrid[52][1] c_mygrid[53][1] c_mygrid[54][1] c_mygrid[55][1] c_mygrid[56][1] c_mygrid[57][1] c_mygrid[58][1] c_mygrid[59][1] & + c_mygrid[60][1] c_mygrid[61][1] c_mygrid[62][1] c_mygrid[63][1] c_mygrid[64][1] c_mygrid[65][1] c_mygrid[66][1] c_mygrid[67][1] c_mygrid[68][1] c_mygrid[69][1] & + c_mygrid[70][1] c_mygrid[71][1] c_mygrid[72][1] c_mygrid[73][1] c_mygrid[74][1] c_mygrid[75][1] c_mygrid[76][1] c_mygrid[77][1] c_mygrid[78][1] c_mygrid[79][1] & + c_mygrid[80][1] c_mygrid[81][1] c_mygrid[82][1] c_mygrid[83][1] c_mygrid[84][1] c_mygrid[85][1] c_mygrid[86][1] c_mygrid[87][1] c_mygrid[88][1] c_mygrid[89][1] & + c_mygrid[90][1] c_mygrid[91][1] c_mygrid[92][1] c_mygrid[93][1] c_mygrid[94][1] c_mygrid[95][1] c_mygrid[96][1] c_mygrid[97][1] c_mygrid[98][1] c_mygrid[99][1] & + c_mygrid[101][1] c_mygrid[102][1] c_mygrid[103][1] c_mygrid[104][1] c_mygrid[105][1] c_mygrid[106][1] c_mygrid[107][1] c_mygrid[108][1] c_mygrid[109][1] & + c_mygrid[110][1] c_mygrid[111][1] c_mygrid[112][1] c_mygrid[113][1] c_mygrid[114][1] c_mygrid[115][1] c_mygrid[116][1] c_mygrid[117][1] c_mygrid[118][1] c_mygrid[119][1] & + c_mygrid[120][1] c_mygrid[121][1] c_mygrid[122][1] c_mygrid[123][1] c_mygrid[124][1] c_mygrid[125][1] c_mygrid[126][1] c_mygrid[127][1] c_mygrid[128][1] c_mygrid[129][1] & + c_mygrid[130][1] c_mygrid[131][1] c_mygrid[132][1] c_mygrid[133][1] c_mygrid[134][1] c_mygrid[135][1] c_mygrid[136][1] c_mygrid[137][1] c_mygrid[138][1] c_mygrid[139][1] & + c_mygrid[140][1] c_mygrid[141][1] c_mygrid[142][1] c_mygrid[143][1] c_mygrid[144][1] c_mygrid[145][1] c_mygrid[146][1] c_mygrid[147][1] c_mygrid[148][1] c_mygrid[149][1] & + c_mygrid[150][1] c_mygrid[151][1] c_mygrid[152][1] c_mygrid[153][1] c_mygrid[154][1] c_mygrid[155][1] c_mygrid[156][1] c_mygrid[157][1] c_mygrid[158][1] c_mygrid[159][1] & + c_mygrid[160][1] c_mygrid[161][1] c_mygrid[162][1] c_mygrid[163][1] c_mygrid[164][1] c_mygrid[165][1] c_mygrid[166][1] c_mygrid[167][1] c_mygrid[168][1] c_mygrid[169][1] & + c_mygrid[170][1] c_mygrid[171][1] c_mygrid[172][1] c_mygrid[173][1] c_mygrid[174][1] c_mygrid[175][1] c_mygrid[176][1] c_mygrid[177][1] c_mygrid[178][1] c_mygrid[179][1] & + c_mygrid[180][1] c_mygrid[181][1] c_mygrid[182][1] c_mygrid[183][1] c_mygrid[184][1] c_mygrid[185][1] c_mygrid[186][1] c_mygrid[187][1] c_mygrid[188][1] c_mygrid[189][1] & + c_mygrid[190][1] c_mygrid[191][1] c_mygrid[192][1] c_mygrid[193][1] c_mygrid[194][1] c_mygrid[195][1] c_mygrid[196][1] c_mygrid[197][1] c_mygrid[198][1] c_mygrid[199][1] & + c_mygrid[201][1] c_mygrid[202][1] c_mygrid[203][1] c_mygrid[204][1] c_mygrid[205][1] c_mygrid[206][1] c_mygrid[207][1] c_mygrid[208][1] c_mygrid[209][1] & + c_mygrid[210][1] c_mygrid[211][1] c_mygrid[212][1] c_mygrid[213][1] c_mygrid[214][1] c_mygrid[215][1] c_mygrid[216][1] c_mygrid[217][1] c_mygrid[218][1] c_mygrid[219][1] & + c_mygrid[220][1] c_mygrid[221][1] c_mygrid[222][1] c_mygrid[223][1] c_mygrid[224][1] c_mygrid[225][1] c_mygrid[226][1] c_mygrid[227][1] c_mygrid[228][1] c_mygrid[229][1] & + c_mygrid[230][1] c_mygrid[231][1] c_mygrid[232][1] c_mygrid[233][1] c_mygrid[234][1] c_mygrid[235][1] c_mygrid[236][1] c_mygrid[237][1] c_mygrid[238][1] c_mygrid[239][1] & + c_mygrid[240][1] c_mygrid[241][1] c_mygrid[242][1] c_mygrid[243][1] c_mygrid[244][1] c_mygrid[245][1] c_mygrid[246][1] c_mygrid[247][1] c_mygrid[248][1] c_mygrid[249][1] & + c_mygrid[250][1] c_mygrid[251][1] c_mygrid[252][1] c_mygrid[253][1] c_mygrid[254][1] c_mygrid[255][1] c_mygrid[256][1] c_mygrid[257][1] c_mygrid[258][1] c_mygrid[259][1] & + c_mygrid[260][1] c_mygrid[261][1] c_mygrid[262][1] c_mygrid[263][1] c_mygrid[264][1] c_mygrid[265][1] c_mygrid[266][1] c_mygrid[267][1] c_mygrid[268][1] c_mygrid[269][1] & + c_mygrid[270][1] c_mygrid[271][1] c_mygrid[272][1] c_mygrid[273][1] c_mygrid[274][1] c_mygrid[275][1] c_mygrid[276][1] c_mygrid[277][1] c_mygrid[278][1] c_mygrid[279][1] & + c_mygrid[280][1] c_mygrid[281][1] c_mygrid[282][1] c_mygrid[283][1] c_mygrid[284][1] c_mygrid[285][1] c_mygrid[286][1] c_mygrid[287][1] c_mygrid[288][1] c_mygrid[289][1] & + c_mygrid[290][1] c_mygrid[291][1] c_mygrid[292][1] c_mygrid[293][1] c_mygrid[294][1] c_mygrid[295][1] c_mygrid[296][1] c_mygrid[297][1] c_mygrid[298][1] c_mygrid[299][1] & + c_mygrid[301][1] c_mygrid[302][1] c_mygrid[303][1] c_mygrid[304][1] c_mygrid[305][1] c_mygrid[306][1] c_mygrid[307][1] c_mygrid[308][1] c_mygrid[309][1] & + c_mygrid[310][1] c_mygrid[311][1] c_mygrid[312][1] c_mygrid[313][1] c_mygrid[314][1] c_mygrid[315][1] c_mygrid[316][1] c_mygrid[317][1] c_mygrid[318][1] c_mygrid[319][1] & + c_mygrid[320][1] c_mygrid[321][1] c_mygrid[322][1] c_mygrid[323][1] c_mygrid[324][1] c_mygrid[325][1] c_mygrid[326][1] c_mygrid[327][1] c_mygrid[328][1] c_mygrid[329][1] & + c_mygrid[330][1] c_mygrid[331][1] c_mygrid[332][1] c_mygrid[333][1] c_mygrid[334][1] c_mygrid[335][1] c_mygrid[336][1] c_mygrid[337][1] c_mygrid[338][1] c_mygrid[339][1] & + c_mygrid[340][1] c_mygrid[341][1] c_mygrid[342][1] c_mygrid[343][1] c_mygrid[344][1] c_mygrid[345][1] c_mygrid[346][1] c_mygrid[347][1] c_mygrid[348][1] c_mygrid[349][1] & + c_mygrid[350][1] c_mygrid[351][1] c_mygrid[352][1] c_mygrid[353][1] c_mygrid[354][1] c_mygrid[355][1] c_mygrid[356][1] c_mygrid[357][1] c_mygrid[358][1] c_mygrid[359][1] & + c_mygrid[360][1] c_mygrid[361][1] c_mygrid[362][1] c_mygrid[363][1] c_mygrid[364][1] c_mygrid[365][1] c_mygrid[366][1] c_mygrid[367][1] c_mygrid[368][1] c_mygrid[369][1] & + c_mygrid[370][1] c_mygrid[371][1] c_mygrid[372][1] c_mygrid[373][1] c_mygrid[374][1] c_mygrid[375][1] c_mygrid[376][1] c_mygrid[377][1] c_mygrid[378][1] c_mygrid[379][1] & + c_mygrid[380][1] c_mygrid[381][1] c_mygrid[382][1] c_mygrid[383][1] c_mygrid[384][1] + +thermo_modify norm yes + +dump mydump_b all custom 1000 dump_b id c_b[*] + +# run + +run 0 + diff --git a/src/compute_sna_grid.cpp b/src/SNAP/compute_sna_grid.cpp similarity index 100% rename from src/compute_sna_grid.cpp rename to src/SNAP/compute_sna_grid.cpp diff --git a/src/compute_sna_grid.h b/src/SNAP/compute_sna_grid.h similarity index 100% rename from src/compute_sna_grid.h rename to src/SNAP/compute_sna_grid.h diff --git a/src/compute_grid.cpp b/src/compute_grid.cpp index d8c7eb3697..ec969fd01f 100644 --- a/src/compute_grid.cpp +++ b/src/compute_grid.cpp @@ -34,7 +34,7 @@ ComputeGrid::ComputeGrid(LAMMPS *lmp, int narg, char **arg) : array_flag = 1; size_array_cols = 0; size_array_rows = 0; - extarray = 1; + extarray = 0; int iarg0 = 3; int iarg = iarg0; @@ -119,10 +119,6 @@ void ComputeGrid::setup() + pow(delxy*my,2))*delxinvtmp + 1; } - printf("mx = %d\n",mx); - printf("my = %d\n",my); - printf("mz = %d\n",mz); - // size global grid to accomodate periodic interactions nxfull = nx + 2*mx; @@ -130,10 +126,6 @@ void ComputeGrid::setup() nzfull = nz + 2*mz; nxyfull = nxfull * nyfull; - printf("nxfull = %d\n",nxfull); - printf("nyfull = %d\n",nyfull); - printf("nzfull = %d\n",nzfull); - x0full = boxlo[0] - mx*delx; y0full = boxlo[1] - my*dely; z0full = boxlo[2] - mz*delz; @@ -148,9 +140,9 @@ void ComputeGrid::setup() void ComputeGrid::igridfull2x(int igrid, double *x) { int iz = igrid / nxyfull; - igrid -= iz*nxyfull; + igrid -= iz * nxyfull; int iy = igrid / nxfull; - igrid -= igrid*nxfull; + igrid -= iy * nxfull; int ix = igrid; x[0] = x0full+ix*delx; @@ -161,14 +153,28 @@ void ComputeGrid::igridfull2x(int igrid, double *x) } +/* ---------------------------------------------------------------------- + copy local grid to global array +------------------------------------------------------------------------- */ + +void ComputeGrid::copy_local_grid() +{ + int igridfull; + for (int iarray = 0; iarray < size_array_rows; iarray++) { + igridfull = iarray2igridfull(iarray); + for (int icol = 0; icol < size_array_cols; icol++) + array[iarray][icol] = gridfull[igridfull][icol]; + } +} + /* ---------------------------------------------------------------------- gather global array from full grid ------------------------------------------------------------------------- */ void ComputeGrid::gather_global_array() { - int iarray; - memset(&array[0][0],0,size_array_rows*size_array_cols*sizeof(double)); + int iarray; + memset(&array[0][0],0,size_array_rows*size_array_cols*sizeof(double)); for (int igrid = 0; igrid < ngridfull; igrid++) { @@ -190,7 +196,7 @@ int ComputeGrid::igridfull2iarray(int igrid) int iz = igrid / nxyfull; igrid -= iz*nxyfull; int iy = igrid / nxfull; - igrid -= igrid*nxfull; + igrid -= iy*nxfull; int ix = igrid; ix -= mx; @@ -210,6 +216,28 @@ int ComputeGrid::igridfull2iarray(int igrid) return iarray; } +/* ---------------------------------------------------------------------- + convert compute array index to full grid index + inefficient, should exploit shared ix structure +------------------------------------------------------------------------- */ + +int ComputeGrid::iarray2igridfull(int iarray) +{ + int iz = iarray / (nx*ny); + iarray -= iz*(nx*ny); + int iy = iarray / nx; + iarray -= iy*nx; + int ix = iarray; + + ix += mx; + iy += my; + iz += mz; + + int igrid = (iz * nyfull + iy) * nxfull + ix; + + return igrid; +} + /* ---------------------------------------------------------------------- free and reallocate arrays ------------------------------------------------------------------------- */ diff --git a/src/compute_grid.h b/src/compute_grid.h index 61775186ff..bc757c37bc 100644 --- a/src/compute_grid.h +++ b/src/compute_grid.h @@ -46,7 +46,9 @@ class ComputeGrid : public Compute { virtual void allocate(); void igridfull2x(int, double*); // convert full grid point to coord void gather_global_array(); // gather global array from full grid + void copy_local_grid(); // copy local grid to global array int igridfull2iarray(int); // convert full grid index to compute array index + int iarray2igridfull(int); // convert compute array index to full grid index private: }; From 0fc325c98b2b4ffd8fb24cd53ce732221add6ac0 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Wed, 23 Oct 2019 18:56:21 -0600 Subject: [PATCH 004/585] Got a first pass working for ortho and tri grids --- src/SNAP/compute_sna_grid.cpp | 24 +++++++++--------------- 1 file changed, 9 insertions(+), 15 deletions(-) diff --git a/src/SNAP/compute_sna_grid.cpp b/src/SNAP/compute_sna_grid.cpp index 1f998ced9b..26bd272d9f 100644 --- a/src/SNAP/compute_sna_grid.cpp +++ b/src/SNAP/compute_sna_grid.cpp @@ -66,7 +66,6 @@ ComputeSNAGrid::ComputeSNAGrid(LAMMPS *lmp, int narg, char **arg) : rcutfac = atof(arg[3]); rfac0 = atof(arg[4]); twojmax = atoi(arg[5]); - printf("rcutfac = %g rfac0 = %g twojmax = %d\n",rcutfac, rfac0, twojmax); for(int i = 0; i < ntypes; i++) radelem[i+1] = atof(arg[6+i]); @@ -82,7 +81,6 @@ ComputeSNAGrid::ComputeSNAGrid(LAMMPS *lmp, int narg, char **arg) : cut = 2.0*radelem[i]*rcutfac; if (cut > cutmax) cutmax = cut; cutsq[i][i] = cut*cut; - printf("i = %d cutsq[i][i] = %g\n",i,cutsq[i][i]); for(int j = i+1; j <= ntypes; j++) { cut = (radelem[i]+radelem[j])*rcutfac; cutsq[i][j] = cutsq[j][i] = cut*cut; @@ -94,7 +92,6 @@ ComputeSNAGrid::ComputeSNAGrid(LAMMPS *lmp, int narg, char **arg) : int iarg = nargmin; while (iarg < narg) { - printf("iarg = %d arg = %s\n",iarg, arg[iarg]); if (strcmp(arg[iarg],"rmin0") == 0) { if (iarg+2 > narg) error->all(FLERR,"Illegal compute sna/grid command"); @@ -119,9 +116,6 @@ ComputeSNAGrid::ComputeSNAGrid(LAMMPS *lmp, int narg, char **arg) : } - printf("rmin0 = %g, bzeroflag = %d, quadraticflag = %d\n", - rmin0, bzeroflag, quadraticflag); - snaptr = new SNA(lmp,rfac0,twojmax, rmin0,switchflag,bzeroflag); @@ -199,9 +193,12 @@ void ComputeSNAGrid::compute_array() const int* const mask = atom->mask; const int ntotal = atom->nlocal + atom->nghost; + // insure rij, inside, and typej are of size jnum + + snaptr->grow_rij(ntotal); + printf("ngridfull = %d\n",ngridfull); for (int igrid = 0; igrid < ngridfull; igrid++) { - printf("igrid = %d\n",igrid); double rtmp[3]; igridfull2x(igrid, rtmp); const double xtmp = rtmp[0]; @@ -215,21 +212,17 @@ void ComputeSNAGrid::compute_array() int ninside = 0; for (int j = 0; j < ntotal; j++) { - // check that j is in comute group + // check that j is in compute group if (!(mask[j] & groupbit)) continue; - // insure rij, inside, and typej are of size jnum - - snaptr->grow_rij(ninside+1); - const double delx = xtmp - x[j][0]; const double dely = ytmp - x[j][1]; const double delz = ztmp - x[j][2]; const double rsq = delx*delx + dely*dely + delz*delz; int jtype = type[j]; if (rsq < cutsq[jtype][jtype] && rsq>1e-20) { - printf("ninside = %d\n",ninside); + // printf("ninside = %d\n",ninside); snaptr->rij[ninside][0] = delx; snaptr->rij[ninside][1] = dely; snaptr->rij[ninside][2] = delz; @@ -245,7 +238,7 @@ void ComputeSNAGrid::compute_array() snaptr->compute_bi(); for (int icoeff = 0; icoeff < ncoeff; icoeff++) sna[igrid][icoeff] = snaptr->blist[icoeff]; - printf("igrid = %d B0 = %g\n",igrid,sna[igrid][0]); + // printf("igrid = %d %g %g %g %d B0 = %g\n",igrid,xtmp,ytmp,ztmp,ninside,sna[igrid][0]); if (quadraticflag) { int ncount = ncoeff; for (int icoeff = 0; icoeff < ncoeff; icoeff++) { @@ -262,7 +255,8 @@ void ComputeSNAGrid::compute_array() } } } - gather_global_array(); + // gather_global_array(); + copy_local_grid(); } /* ---------------------------------------------------------------------- From 5956908cfd2bbd097be8126cc4f062d5cc9cc519 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Wed, 23 Oct 2019 21:51:36 -0600 Subject: [PATCH 005/585] Added cols for coords --- examples/snap/in.grid | 6 ++- examples/snap/in.grid.tri | 78 +++++++++++++++++------------------ src/SNAP/compute_sna_grid.cpp | 6 +-- src/compute_grid.cpp | 41 +++++++++++++++++- src/compute_grid.h | 5 ++- 5 files changed, 90 insertions(+), 46 deletions(-) diff --git a/examples/snap/in.grid b/examples/snap/in.grid index bec57dc9ff..5293558fab 100644 --- a/examples/snap/in.grid +++ b/examples/snap/in.grid @@ -60,7 +60,11 @@ compute mygrid all sna/grid grid ${ngrid} ${ngrid} ${ngrid} & # define output -thermo_style custom step temp ke pe vol c_mygrid[1][1] c_mygrid[2][1] c_mygrid[3][1] c_mygrid[4][1] c_mygrid[5][1] c_mygrid[6][1] c_mygrid[7][1] c_mygrid[8][1] +thermo_style custom step temp ke pe vol & + c_mygrid[1][1] c_mygrid[2][1] c_mygrid[3][1] c_mygrid[4][1] c_mygrid[5][1] c_mygrid[6][1] c_mygrid[7][1] c_mygrid[8][1] & + c_mygrid[1][2] c_mygrid[2][2] c_mygrid[3][2] c_mygrid[4][2] c_mygrid[5][2] c_mygrid[6][2] c_mygrid[7][2] c_mygrid[8][2] & + c_mygrid[1][3] c_mygrid[2][3] c_mygrid[3][3] c_mygrid[4][3] c_mygrid[5][3] c_mygrid[6][3] c_mygrid[7][3] c_mygrid[8][3] & + c_mygrid[1][4] c_mygrid[2][4] c_mygrid[3][4] c_mygrid[4][4] c_mygrid[5][4] c_mygrid[6][4] c_mygrid[7][4] c_mygrid[8][4] thermo_modify norm yes dump mydump_b all custom 1000 dump_b id c_b[*] diff --git a/examples/snap/in.grid.tri b/examples/snap/in.grid.tri index c02138f66a..3c471d9b66 100644 --- a/examples/snap/in.grid.tri +++ b/examples/snap/in.grid.tri @@ -66,45 +66,45 @@ compute mygrid all sna/grid grid ${ngridx} ${ngridy} ${ngridz} & # define output thermo_style custom step temp ke pe vol & - c_mygrid[1][1] c_mygrid[2][1] c_mygrid[3][1] c_mygrid[4][1] c_mygrid[5][1] c_mygrid[6][1] c_mygrid[7][1] c_mygrid[8][1] c_mygrid[9][1] & - c_mygrid[10][1] c_mygrid[11][1] c_mygrid[12][1] c_mygrid[13][1] c_mygrid[14][1] c_mygrid[15][1] c_mygrid[16][1] c_mygrid[17][1] c_mygrid[18][1] c_mygrid[19][1] & - c_mygrid[20][1] c_mygrid[21][1] c_mygrid[22][1] c_mygrid[23][1] c_mygrid[24][1] c_mygrid[25][1] c_mygrid[26][1] c_mygrid[27][1] c_mygrid[28][1] c_mygrid[29][1] & - c_mygrid[30][1] c_mygrid[31][1] c_mygrid[32][1] c_mygrid[33][1] c_mygrid[34][1] c_mygrid[35][1] c_mygrid[36][1] c_mygrid[37][1] c_mygrid[38][1] c_mygrid[39][1] & - c_mygrid[40][1] c_mygrid[41][1] c_mygrid[42][1] c_mygrid[43][1] c_mygrid[44][1] c_mygrid[45][1] c_mygrid[46][1] c_mygrid[47][1] c_mygrid[48][1] c_mygrid[49][1] & - c_mygrid[50][1] c_mygrid[51][1] c_mygrid[52][1] c_mygrid[53][1] c_mygrid[54][1] c_mygrid[55][1] c_mygrid[56][1] c_mygrid[57][1] c_mygrid[58][1] c_mygrid[59][1] & - c_mygrid[60][1] c_mygrid[61][1] c_mygrid[62][1] c_mygrid[63][1] c_mygrid[64][1] c_mygrid[65][1] c_mygrid[66][1] c_mygrid[67][1] c_mygrid[68][1] c_mygrid[69][1] & - c_mygrid[70][1] c_mygrid[71][1] c_mygrid[72][1] c_mygrid[73][1] c_mygrid[74][1] c_mygrid[75][1] c_mygrid[76][1] c_mygrid[77][1] c_mygrid[78][1] c_mygrid[79][1] & - c_mygrid[80][1] c_mygrid[81][1] c_mygrid[82][1] c_mygrid[83][1] c_mygrid[84][1] c_mygrid[85][1] c_mygrid[86][1] c_mygrid[87][1] c_mygrid[88][1] c_mygrid[89][1] & - c_mygrid[90][1] c_mygrid[91][1] c_mygrid[92][1] c_mygrid[93][1] c_mygrid[94][1] c_mygrid[95][1] c_mygrid[96][1] c_mygrid[97][1] c_mygrid[98][1] c_mygrid[99][1] & - c_mygrid[101][1] c_mygrid[102][1] c_mygrid[103][1] c_mygrid[104][1] c_mygrid[105][1] c_mygrid[106][1] c_mygrid[107][1] c_mygrid[108][1] c_mygrid[109][1] & - c_mygrid[110][1] c_mygrid[111][1] c_mygrid[112][1] c_mygrid[113][1] c_mygrid[114][1] c_mygrid[115][1] c_mygrid[116][1] c_mygrid[117][1] c_mygrid[118][1] c_mygrid[119][1] & - c_mygrid[120][1] c_mygrid[121][1] c_mygrid[122][1] c_mygrid[123][1] c_mygrid[124][1] c_mygrid[125][1] c_mygrid[126][1] c_mygrid[127][1] c_mygrid[128][1] c_mygrid[129][1] & - c_mygrid[130][1] c_mygrid[131][1] c_mygrid[132][1] c_mygrid[133][1] c_mygrid[134][1] c_mygrid[135][1] c_mygrid[136][1] c_mygrid[137][1] c_mygrid[138][1] c_mygrid[139][1] & - c_mygrid[140][1] c_mygrid[141][1] c_mygrid[142][1] c_mygrid[143][1] c_mygrid[144][1] c_mygrid[145][1] c_mygrid[146][1] c_mygrid[147][1] c_mygrid[148][1] c_mygrid[149][1] & - c_mygrid[150][1] c_mygrid[151][1] c_mygrid[152][1] c_mygrid[153][1] c_mygrid[154][1] c_mygrid[155][1] c_mygrid[156][1] c_mygrid[157][1] c_mygrid[158][1] c_mygrid[159][1] & - c_mygrid[160][1] c_mygrid[161][1] c_mygrid[162][1] c_mygrid[163][1] c_mygrid[164][1] c_mygrid[165][1] c_mygrid[166][1] c_mygrid[167][1] c_mygrid[168][1] c_mygrid[169][1] & - c_mygrid[170][1] c_mygrid[171][1] c_mygrid[172][1] c_mygrid[173][1] c_mygrid[174][1] c_mygrid[175][1] c_mygrid[176][1] c_mygrid[177][1] c_mygrid[178][1] c_mygrid[179][1] & - c_mygrid[180][1] c_mygrid[181][1] c_mygrid[182][1] c_mygrid[183][1] c_mygrid[184][1] c_mygrid[185][1] c_mygrid[186][1] c_mygrid[187][1] c_mygrid[188][1] c_mygrid[189][1] & - c_mygrid[190][1] c_mygrid[191][1] c_mygrid[192][1] c_mygrid[193][1] c_mygrid[194][1] c_mygrid[195][1] c_mygrid[196][1] c_mygrid[197][1] c_mygrid[198][1] c_mygrid[199][1] & - c_mygrid[201][1] c_mygrid[202][1] c_mygrid[203][1] c_mygrid[204][1] c_mygrid[205][1] c_mygrid[206][1] c_mygrid[207][1] c_mygrid[208][1] c_mygrid[209][1] & - c_mygrid[210][1] c_mygrid[211][1] c_mygrid[212][1] c_mygrid[213][1] c_mygrid[214][1] c_mygrid[215][1] c_mygrid[216][1] c_mygrid[217][1] c_mygrid[218][1] c_mygrid[219][1] & - c_mygrid[220][1] c_mygrid[221][1] c_mygrid[222][1] c_mygrid[223][1] c_mygrid[224][1] c_mygrid[225][1] c_mygrid[226][1] c_mygrid[227][1] c_mygrid[228][1] c_mygrid[229][1] & - c_mygrid[230][1] c_mygrid[231][1] c_mygrid[232][1] c_mygrid[233][1] c_mygrid[234][1] c_mygrid[235][1] c_mygrid[236][1] c_mygrid[237][1] c_mygrid[238][1] c_mygrid[239][1] & - c_mygrid[240][1] c_mygrid[241][1] c_mygrid[242][1] c_mygrid[243][1] c_mygrid[244][1] c_mygrid[245][1] c_mygrid[246][1] c_mygrid[247][1] c_mygrid[248][1] c_mygrid[249][1] & - c_mygrid[250][1] c_mygrid[251][1] c_mygrid[252][1] c_mygrid[253][1] c_mygrid[254][1] c_mygrid[255][1] c_mygrid[256][1] c_mygrid[257][1] c_mygrid[258][1] c_mygrid[259][1] & - c_mygrid[260][1] c_mygrid[261][1] c_mygrid[262][1] c_mygrid[263][1] c_mygrid[264][1] c_mygrid[265][1] c_mygrid[266][1] c_mygrid[267][1] c_mygrid[268][1] c_mygrid[269][1] & - c_mygrid[270][1] c_mygrid[271][1] c_mygrid[272][1] c_mygrid[273][1] c_mygrid[274][1] c_mygrid[275][1] c_mygrid[276][1] c_mygrid[277][1] c_mygrid[278][1] c_mygrid[279][1] & - c_mygrid[280][1] c_mygrid[281][1] c_mygrid[282][1] c_mygrid[283][1] c_mygrid[284][1] c_mygrid[285][1] c_mygrid[286][1] c_mygrid[287][1] c_mygrid[288][1] c_mygrid[289][1] & - c_mygrid[290][1] c_mygrid[291][1] c_mygrid[292][1] c_mygrid[293][1] c_mygrid[294][1] c_mygrid[295][1] c_mygrid[296][1] c_mygrid[297][1] c_mygrid[298][1] c_mygrid[299][1] & - c_mygrid[301][1] c_mygrid[302][1] c_mygrid[303][1] c_mygrid[304][1] c_mygrid[305][1] c_mygrid[306][1] c_mygrid[307][1] c_mygrid[308][1] c_mygrid[309][1] & - c_mygrid[310][1] c_mygrid[311][1] c_mygrid[312][1] c_mygrid[313][1] c_mygrid[314][1] c_mygrid[315][1] c_mygrid[316][1] c_mygrid[317][1] c_mygrid[318][1] c_mygrid[319][1] & - c_mygrid[320][1] c_mygrid[321][1] c_mygrid[322][1] c_mygrid[323][1] c_mygrid[324][1] c_mygrid[325][1] c_mygrid[326][1] c_mygrid[327][1] c_mygrid[328][1] c_mygrid[329][1] & - c_mygrid[330][1] c_mygrid[331][1] c_mygrid[332][1] c_mygrid[333][1] c_mygrid[334][1] c_mygrid[335][1] c_mygrid[336][1] c_mygrid[337][1] c_mygrid[338][1] c_mygrid[339][1] & - c_mygrid[340][1] c_mygrid[341][1] c_mygrid[342][1] c_mygrid[343][1] c_mygrid[344][1] c_mygrid[345][1] c_mygrid[346][1] c_mygrid[347][1] c_mygrid[348][1] c_mygrid[349][1] & - c_mygrid[350][1] c_mygrid[351][1] c_mygrid[352][1] c_mygrid[353][1] c_mygrid[354][1] c_mygrid[355][1] c_mygrid[356][1] c_mygrid[357][1] c_mygrid[358][1] c_mygrid[359][1] & - c_mygrid[360][1] c_mygrid[361][1] c_mygrid[362][1] c_mygrid[363][1] c_mygrid[364][1] c_mygrid[365][1] c_mygrid[366][1] c_mygrid[367][1] c_mygrid[368][1] c_mygrid[369][1] & - c_mygrid[370][1] c_mygrid[371][1] c_mygrid[372][1] c_mygrid[373][1] c_mygrid[374][1] c_mygrid[375][1] c_mygrid[376][1] c_mygrid[377][1] c_mygrid[378][1] c_mygrid[379][1] & - c_mygrid[380][1] c_mygrid[381][1] c_mygrid[382][1] c_mygrid[383][1] c_mygrid[384][1] + c_mygrid[1][4] c_mygrid[2][4] c_mygrid[3][4] c_mygrid[4][4] c_mygrid[5][4] c_mygrid[6][4] c_mygrid[7][4] c_mygrid[8][4] c_mygrid[9][4] & + c_mygrid[10][4] c_mygrid[11][4] c_mygrid[12][4] c_mygrid[13][4] c_mygrid[14][4] c_mygrid[15][4] c_mygrid[16][4] c_mygrid[17][4] c_mygrid[18][4] c_mygrid[19][4] & + c_mygrid[20][4] c_mygrid[21][4] c_mygrid[22][4] c_mygrid[23][4] c_mygrid[24][4] c_mygrid[25][4] c_mygrid[26][4] c_mygrid[27][4] c_mygrid[28][4] c_mygrid[29][4] & + c_mygrid[30][4] c_mygrid[31][4] c_mygrid[32][4] c_mygrid[33][4] c_mygrid[34][4] c_mygrid[35][4] c_mygrid[36][4] c_mygrid[37][4] c_mygrid[38][4] c_mygrid[39][4] & + c_mygrid[40][4] c_mygrid[41][4] c_mygrid[42][4] c_mygrid[43][4] c_mygrid[44][4] c_mygrid[45][4] c_mygrid[46][4] c_mygrid[47][4] c_mygrid[48][4] c_mygrid[49][4] & + c_mygrid[50][4] c_mygrid[51][4] c_mygrid[52][4] c_mygrid[53][4] c_mygrid[54][4] c_mygrid[55][4] c_mygrid[56][4] c_mygrid[57][4] c_mygrid[58][4] c_mygrid[59][4] & + c_mygrid[60][4] c_mygrid[61][4] c_mygrid[62][4] c_mygrid[63][4] c_mygrid[64][4] c_mygrid[65][4] c_mygrid[66][4] c_mygrid[67][4] c_mygrid[68][4] c_mygrid[69][4] & + c_mygrid[70][4] c_mygrid[71][4] c_mygrid[72][4] c_mygrid[73][4] c_mygrid[74][4] c_mygrid[75][4] c_mygrid[76][4] c_mygrid[77][4] c_mygrid[78][4] c_mygrid[79][4] & + c_mygrid[80][4] c_mygrid[81][4] c_mygrid[82][4] c_mygrid[83][4] c_mygrid[84][4] c_mygrid[85][4] c_mygrid[86][4] c_mygrid[87][4] c_mygrid[88][4] c_mygrid[89][4] & + c_mygrid[90][4] c_mygrid[91][4] c_mygrid[92][4] c_mygrid[93][4] c_mygrid[94][4] c_mygrid[95][4] c_mygrid[96][4] c_mygrid[97][4] c_mygrid[98][4] c_mygrid[99][4] & + c_mygrid[101][4] c_mygrid[102][4] c_mygrid[103][4] c_mygrid[104][4] c_mygrid[105][4] c_mygrid[106][4] c_mygrid[107][4] c_mygrid[108][4] c_mygrid[109][4] & + c_mygrid[110][4] c_mygrid[111][4] c_mygrid[112][4] c_mygrid[113][4] c_mygrid[114][4] c_mygrid[115][4] c_mygrid[116][4] c_mygrid[117][4] c_mygrid[118][4] c_mygrid[119][4] & + c_mygrid[120][4] c_mygrid[121][4] c_mygrid[122][4] c_mygrid[123][4] c_mygrid[124][4] c_mygrid[125][4] c_mygrid[126][4] c_mygrid[127][4] c_mygrid[128][4] c_mygrid[129][4] & + c_mygrid[130][4] c_mygrid[131][4] c_mygrid[132][4] c_mygrid[133][4] c_mygrid[134][4] c_mygrid[135][4] c_mygrid[136][4] c_mygrid[137][4] c_mygrid[138][4] c_mygrid[139][4] & + c_mygrid[140][4] c_mygrid[141][4] c_mygrid[142][4] c_mygrid[143][4] c_mygrid[144][4] c_mygrid[145][4] c_mygrid[146][4] c_mygrid[147][4] c_mygrid[148][4] c_mygrid[149][4] & + c_mygrid[150][4] c_mygrid[151][4] c_mygrid[152][4] c_mygrid[153][4] c_mygrid[154][4] c_mygrid[155][4] c_mygrid[156][4] c_mygrid[157][4] c_mygrid[158][4] c_mygrid[159][4] & + c_mygrid[160][4] c_mygrid[161][4] c_mygrid[162][4] c_mygrid[163][4] c_mygrid[164][4] c_mygrid[165][4] c_mygrid[166][4] c_mygrid[167][4] c_mygrid[168][4] c_mygrid[169][4] & + c_mygrid[170][4] c_mygrid[171][4] c_mygrid[172][4] c_mygrid[173][4] c_mygrid[174][4] c_mygrid[175][4] c_mygrid[176][4] c_mygrid[177][4] c_mygrid[178][4] c_mygrid[179][4] & + c_mygrid[180][4] c_mygrid[181][4] c_mygrid[182][4] c_mygrid[183][4] c_mygrid[184][4] c_mygrid[185][4] c_mygrid[186][4] c_mygrid[187][4] c_mygrid[188][4] c_mygrid[189][4] & + c_mygrid[190][4] c_mygrid[191][4] c_mygrid[192][4] c_mygrid[193][4] c_mygrid[194][4] c_mygrid[195][4] c_mygrid[196][4] c_mygrid[197][4] c_mygrid[198][4] c_mygrid[199][4] & + c_mygrid[201][4] c_mygrid[202][4] c_mygrid[203][4] c_mygrid[204][4] c_mygrid[205][4] c_mygrid[206][4] c_mygrid[207][4] c_mygrid[208][4] c_mygrid[209][4] & + c_mygrid[210][4] c_mygrid[211][4] c_mygrid[212][4] c_mygrid[213][4] c_mygrid[214][4] c_mygrid[215][4] c_mygrid[216][4] c_mygrid[217][4] c_mygrid[218][4] c_mygrid[219][4] & + c_mygrid[220][4] c_mygrid[221][4] c_mygrid[222][4] c_mygrid[223][4] c_mygrid[224][4] c_mygrid[225][4] c_mygrid[226][4] c_mygrid[227][4] c_mygrid[228][4] c_mygrid[229][4] & + c_mygrid[230][4] c_mygrid[231][4] c_mygrid[232][4] c_mygrid[233][4] c_mygrid[234][4] c_mygrid[235][4] c_mygrid[236][4] c_mygrid[237][4] c_mygrid[238][4] c_mygrid[239][4] & + c_mygrid[240][4] c_mygrid[241][4] c_mygrid[242][4] c_mygrid[243][4] c_mygrid[244][4] c_mygrid[245][4] c_mygrid[246][4] c_mygrid[247][4] c_mygrid[248][4] c_mygrid[249][4] & + c_mygrid[250][4] c_mygrid[251][4] c_mygrid[252][4] c_mygrid[253][4] c_mygrid[254][4] c_mygrid[255][4] c_mygrid[256][4] c_mygrid[257][4] c_mygrid[258][4] c_mygrid[259][4] & + c_mygrid[260][4] c_mygrid[261][4] c_mygrid[262][4] c_mygrid[263][4] c_mygrid[264][4] c_mygrid[265][4] c_mygrid[266][4] c_mygrid[267][4] c_mygrid[268][4] c_mygrid[269][4] & + c_mygrid[270][4] c_mygrid[271][4] c_mygrid[272][4] c_mygrid[273][4] c_mygrid[274][4] c_mygrid[275][4] c_mygrid[276][4] c_mygrid[277][4] c_mygrid[278][4] c_mygrid[279][4] & + c_mygrid[280][4] c_mygrid[281][4] c_mygrid[282][4] c_mygrid[283][4] c_mygrid[284][4] c_mygrid[285][4] c_mygrid[286][4] c_mygrid[287][4] c_mygrid[288][4] c_mygrid[289][4] & + c_mygrid[290][4] c_mygrid[291][4] c_mygrid[292][4] c_mygrid[293][4] c_mygrid[294][4] c_mygrid[295][4] c_mygrid[296][4] c_mygrid[297][4] c_mygrid[298][4] c_mygrid[299][4] & + c_mygrid[301][4] c_mygrid[302][4] c_mygrid[303][4] c_mygrid[304][4] c_mygrid[305][4] c_mygrid[306][4] c_mygrid[307][4] c_mygrid[308][4] c_mygrid[309][4] & + c_mygrid[310][4] c_mygrid[311][4] c_mygrid[312][4] c_mygrid[313][4] c_mygrid[314][4] c_mygrid[315][4] c_mygrid[316][4] c_mygrid[317][4] c_mygrid[318][4] c_mygrid[319][4] & + c_mygrid[320][4] c_mygrid[321][4] c_mygrid[322][4] c_mygrid[323][4] c_mygrid[324][4] c_mygrid[325][4] c_mygrid[326][4] c_mygrid[327][4] c_mygrid[328][4] c_mygrid[329][4] & + c_mygrid[330][4] c_mygrid[331][4] c_mygrid[332][4] c_mygrid[333][4] c_mygrid[334][4] c_mygrid[335][4] c_mygrid[336][4] c_mygrid[337][4] c_mygrid[338][4] c_mygrid[339][4] & + c_mygrid[340][4] c_mygrid[341][4] c_mygrid[342][4] c_mygrid[343][4] c_mygrid[344][4] c_mygrid[345][4] c_mygrid[346][4] c_mygrid[347][4] c_mygrid[348][4] c_mygrid[349][4] & + c_mygrid[350][4] c_mygrid[351][4] c_mygrid[352][4] c_mygrid[353][4] c_mygrid[354][4] c_mygrid[355][4] c_mygrid[356][4] c_mygrid[357][4] c_mygrid[358][4] c_mygrid[359][4] & + c_mygrid[360][4] c_mygrid[361][4] c_mygrid[362][4] c_mygrid[363][4] c_mygrid[364][4] c_mygrid[365][4] c_mygrid[366][4] c_mygrid[367][4] c_mygrid[368][4] c_mygrid[369][4] & + c_mygrid[370][4] c_mygrid[371][4] c_mygrid[372][4] c_mygrid[373][4] c_mygrid[374][4] c_mygrid[375][4] c_mygrid[376][4] c_mygrid[377][4] c_mygrid[378][4] c_mygrid[379][4] & + c_mygrid[380][4] c_mygrid[381][4] c_mygrid[382][4] c_mygrid[383][4] c_mygrid[384][4] thermo_modify norm yes diff --git a/src/SNAP/compute_sna_grid.cpp b/src/SNAP/compute_sna_grid.cpp index 26bd272d9f..d9912cdc47 100644 --- a/src/SNAP/compute_sna_grid.cpp +++ b/src/SNAP/compute_sna_grid.cpp @@ -120,7 +120,7 @@ ComputeSNAGrid::ComputeSNAGrid(LAMMPS *lmp, int narg, char **arg) : rmin0,switchflag,bzeroflag); ncoeff = snaptr->ncoeff; - size_array_cols = ncoeff; + size_array_cols = size_array_cols_base + ncoeff; if (quadraticflag) size_array_cols += (ncoeff*(ncoeff+1))/2; array_flag = 1; } @@ -237,8 +237,8 @@ void ComputeSNAGrid::compute_array() snaptr->compute_zi(); snaptr->compute_bi(); for (int icoeff = 0; icoeff < ncoeff; icoeff++) - sna[igrid][icoeff] = snaptr->blist[icoeff]; - // printf("igrid = %d %g %g %g %d B0 = %g\n",igrid,xtmp,ytmp,ztmp,ninside,sna[igrid][0]); + sna[igrid][size_array_cols_base+icoeff] = snaptr->blist[icoeff]; + // printf("igrid = %d %g %g %g %d B0 = %g\n",igrid,xtmp,ytmp,ztmp,ninside,sna[igrid][size_array_cols_base+0]); if (quadraticflag) { int ncount = ncoeff; for (int icoeff = 0; icoeff < ncoeff; icoeff++) { diff --git a/src/compute_grid.cpp b/src/compute_grid.cpp index ec969fd01f..63e4a8c885 100644 --- a/src/compute_grid.cpp +++ b/src/compute_grid.cpp @@ -51,6 +51,7 @@ ComputeGrid::ComputeGrid(LAMMPS *lmp, int narg, char **arg) : nargbase = iarg - iarg0; size_array_rows = nx*ny*nz; + size_array_cols_base = 3; } /* ---------------------------------------------------------------------- */ @@ -131,6 +132,7 @@ void ComputeGrid::setup() z0full = boxlo[2] - mz*delz; allocate(); + assign_coords_array(); } /* ---------------------------------------------------------------------- @@ -153,6 +155,26 @@ void ComputeGrid::igridfull2x(int igrid, double *x) } +/* ---------------------------------------------------------------------- + convert array index to box coords +------------------------------------------------------------------------- */ + +void ComputeGrid::iarray2x(int iarray, double *x) +{ + int iz = iarray / (nx*ny); + iarray -= iz * (nx*ny); + int iy = iarray / nx; + iarray -= iy * nx; + int ix = iarray; + + x[0] = ix*delx; + x[1] = iy*dely; + x[2] = iz*delz; + + if (triclinic) domain->lamda2x(x, x); + +} + /* ---------------------------------------------------------------------- copy local grid to global array ------------------------------------------------------------------------- */ @@ -162,11 +184,26 @@ void ComputeGrid::copy_local_grid() int igridfull; for (int iarray = 0; iarray < size_array_rows; iarray++) { igridfull = iarray2igridfull(iarray); - for (int icol = 0; icol < size_array_cols; icol++) + for (int icol = size_array_cols_base; icol < size_array_cols; icol++) array[iarray][icol] = gridfull[igridfull][icol]; } } +/* ---------------------------------------------------------------------- + copy coords to global array +------------------------------------------------------------------------- */ + +void ComputeGrid::assign_coords_array() +{ + double x[3]; + for (int iarray = 0; iarray < size_array_rows; iarray++) { + iarray2x(iarray,x); + array[iarray][0] = x[0]; + array[iarray][1] = x[1]; + array[iarray][2] = x[2]; + } +} + /* ---------------------------------------------------------------------- gather global array from full grid ------------------------------------------------------------------------- */ @@ -181,7 +218,7 @@ void ComputeGrid::gather_global_array() // inefficient, should exploit shared ix structure iarray = igridfull2iarray(igrid); - for (int icol = 0; icol < size_array_cols; icol++) + for (int icol = size_array_cols_base; icol < size_array_cols; icol++) array[iarray][icol] += gridfull[igrid][icol]; } } diff --git a/src/compute_grid.h b/src/compute_grid.h index bc757c37bc..1468f9ad91 100644 --- a/src/compute_grid.h +++ b/src/compute_grid.h @@ -33,7 +33,7 @@ class ComputeGrid : public Compute { int nx, ny, nz; // grid dimensions int nxfull, nyfull, nzfull; // grid dimensions with ghost points int nxyfull; // nx_full*ny_full - int ngridfull; // number of full grid points + int ngridfull; // number of full grid points double **gridfull; // full grid points int mx, my, mz; // cutmax stencil dimensions int triclinic; // triclinic flag @@ -43,10 +43,13 @@ class ComputeGrid : public Compute { double x0full, y0full, z0full; // origin of full grid int nargbase; // number of base class args double cutmax; // largest cutoff distance + int size_array_cols_base; // number of columns used for coords, etc. virtual void allocate(); void igridfull2x(int, double*); // convert full grid point to coord + void iarray2x(int, double*); // convert array point to coord void gather_global_array(); // gather global array from full grid void copy_local_grid(); // copy local grid to global array + void assign_coords_array(); // assign coords to global array int igridfull2iarray(int); // convert full grid index to compute array index int iarray2igridfull(int); // convert compute array index to full grid index From 59e3b4c5ba8b3de1d7f183a1cecb793b14886b99 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Thu, 24 Oct 2019 16:12:23 -0600 Subject: [PATCH 006/585] Fixed bug in lammps.py --- python/lammps.py | 11 +++-------- 1 file changed, 3 insertions(+), 8 deletions(-) diff --git a/python/lammps.py b/python/lammps.py index 36cf2d2fdd..f23268cd60 100644 --- a/python/lammps.py +++ b/python/lammps.py @@ -399,14 +399,9 @@ class lammps(object): ptr = self.lib.lammps_extract_compute(self.lmp,id,style,type) return ptr if type == 2: - if style == 0: - self.lib.lammps_extract_compute.restype = POINTER(c_int) - ptr = self.lib.lammps_extract_compute(self.lmp,id,style,type) - return ptr[0] - else: - self.lib.lammps_extract_compute.restype = POINTER(POINTER(c_double)) - ptr = self.lib.lammps_extract_compute(self.lmp,id,style,type) - return ptr + self.lib.lammps_extract_compute.restype = POINTER(POINTER(c_double)) + ptr = self.lib.lammps_extract_compute(self.lmp,id,style,type) + return ptr return None # extract fix info From 2fa9e5fefb26f3e4540ed7dc6e4e1563e49432bc Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Thu, 24 Oct 2019 19:48:41 -0600 Subject: [PATCH 007/585] Completed brute force parallel implementation using MPI_Allreduce() --- src/SNAP/compute_sna_grid.cpp | 60 +++------- src/SNAP/compute_sna_grid.h | 4 - src/compute_grid.cpp | 220 ++++++++++------------------------ src/compute_grid.h | 26 ++-- 4 files changed, 93 insertions(+), 217 deletions(-) diff --git a/src/SNAP/compute_sna_grid.cpp b/src/SNAP/compute_sna_grid.cpp index d9912cdc47..a9f3b6c3fb 100644 --- a/src/SNAP/compute_sna_grid.cpp +++ b/src/SNAP/compute_sna_grid.cpp @@ -31,7 +31,7 @@ using namespace LAMMPS_NS; ComputeSNAGrid::ComputeSNAGrid(LAMMPS *lmp, int narg, char **arg) : - ComputeGrid(lmp, narg, arg), cutsq(NULL), list(NULL), sna(NULL), + ComputeGrid(lmp, narg, arg), cutsq(NULL), sna(NULL), radelem(NULL), wjelem(NULL) { double rmin0, rfac0; @@ -120,8 +120,9 @@ ComputeSNAGrid::ComputeSNAGrid(LAMMPS *lmp, int narg, char **arg) : rmin0,switchflag,bzeroflag); ncoeff = snaptr->ncoeff; - size_array_cols = size_array_cols_base + ncoeff; - if (quadraticflag) size_array_cols += (ncoeff*(ncoeff+1))/2; + nvalues = ncoeff; + if (quadraticflag) nvalues += (ncoeff*(ncoeff+1))/2; + size_array_cols = size_array_cols_base + nvalues; array_flag = 1; } @@ -165,26 +166,10 @@ void ComputeSNAGrid::init() /* ---------------------------------------------------------------------- */ -void ComputeSNAGrid::init_list(int /*id*/, NeighList *ptr) -{ - list = ptr; -} - -/* ---------------------------------------------------------------------- */ - void ComputeSNAGrid::compute_array() { invoked_array = update->ntimestep; -// // invoke full neighbor list (will copy or build if necessary) - -// neighbor->build_one(list); - -// const int inum = list->inum; -// const int* const ilist = list->ilist; -// const int* const numneigh = list->numneigh; -// int** const firstneigh = list->firstneigh; - int * const type = atom->type; // compute sna for each gridpoint @@ -197,13 +182,12 @@ void ComputeSNAGrid::compute_array() snaptr->grow_rij(ntotal); - printf("ngridfull = %d\n",ngridfull); - for (int igrid = 0; igrid < ngridfull; igrid++) { - double rtmp[3]; - igridfull2x(igrid, rtmp); - const double xtmp = rtmp[0]; - const double ytmp = rtmp[1]; - const double ztmp = rtmp[2]; + printf("ngrid = %d\n",ngrid); + for (int igrid = 0; igrid < ngrid; igrid++) { + if (!grid_local[igrid]) continue; + const double xtmp = grid[igrid][0]; + const double ytmp = grid[igrid][1]; + const double ztmp = grid[igrid][2]; // rij[][3] = displacements between atom I and those neighbors // inside = indices of neighbors of I within cutoff @@ -237,7 +221,7 @@ void ComputeSNAGrid::compute_array() snaptr->compute_zi(); snaptr->compute_bi(); for (int icoeff = 0; icoeff < ncoeff; icoeff++) - sna[igrid][size_array_cols_base+icoeff] = snaptr->blist[icoeff]; + grid[igrid][size_array_cols_base+icoeff] = snaptr->blist[icoeff]; // printf("igrid = %d %g %g %g %d B0 = %g\n",igrid,xtmp,ytmp,ztmp,ninside,sna[igrid][size_array_cols_base+0]); if (quadraticflag) { int ncount = ncoeff; @@ -246,27 +230,16 @@ void ComputeSNAGrid::compute_array() // diagonal element of quadratic matrix - sna[igrid][ncount++] = 0.5*bi*bi; + grid[igrid][size_array_cols_base+ncount++] = 0.5*bi*bi; // upper-triangular elements of quadratic matrix for (int jcoeff = icoeff+1; jcoeff < ncoeff; jcoeff++) - sna[igrid][ncount++] = bi*snaptr->blist[jcoeff]; + grid[igrid][size_array_cols_base+ncount++] = bi*snaptr->blist[jcoeff]; } } } - // gather_global_array(); - copy_local_grid(); -} - -/* ---------------------------------------------------------------------- - allocate array in base class and then set up pointers -------------------------------------------------------------------------- */ - -void ComputeSNAGrid::allocate() -{ - ComputeGrid::allocate(); - sna = gridfull; + MPI_Allreduce(&grid[0][0],&gridall[0][0],ngrid*size_array_cols,MPI_DOUBLE,MPI_SUM,world); } /* ---------------------------------------------------------------------- @@ -275,9 +248,8 @@ void ComputeSNAGrid::allocate() double ComputeSNAGrid::memory_usage() { - double bytes = size_array_rows*size_array_cols * sizeof(double); // grid - bytes += snaptr->memory_usage(); // SNA object + double nbytes = snaptr->memory_usage(); // SNA object - return bytes; + return nbytes; } diff --git a/src/SNAP/compute_sna_grid.h b/src/SNAP/compute_sna_grid.h index 2bd18a915e..0242a2962b 100644 --- a/src/SNAP/compute_sna_grid.h +++ b/src/SNAP/compute_sna_grid.h @@ -29,16 +29,12 @@ class ComputeSNAGrid : public ComputeGrid { ComputeSNAGrid(class LAMMPS *, int, char **); ~ComputeSNAGrid(); void init(); - void init_list(int, class NeighList *); void compute_array(); double memory_usage(); - void allocate(); private: - int nmax; int ncoeff; double **cutsq; - class NeighList *list; double **sna; double rcutfac; double *radelem; diff --git a/src/compute_grid.cpp b/src/compute_grid.cpp index 63e4a8c885..2f67d22182 100644 --- a/src/compute_grid.cpp +++ b/src/compute_grid.cpp @@ -50,7 +50,7 @@ ComputeGrid::ComputeGrid(LAMMPS *lmp, int narg, char **arg) : nargbase = iarg - iarg0; - size_array_rows = nx*ny*nz; + size_array_rows = ngrid = nx*ny*nz; size_array_cols_base = 3; } @@ -58,6 +58,8 @@ ComputeGrid::ComputeGrid(LAMMPS *lmp, int narg, char **arg) : ComputeGrid::~ComputeGrid() { + memory->destroy(grid); + memory->destroy(grid_local); } /* ---------------------------------------------------------------------- */ @@ -78,9 +80,13 @@ void ComputeGrid::setup() if (triclinic == 0) { prd = domain->prd; boxlo = domain->boxlo; + sublo = domain->sublo; + subhi = domain->subhi; } else { prd = domain->prd_lamda; boxlo = domain->boxlo_lamda; + sublo = domain->sublo_lamda; + subhi = domain->subhi_lamda; } double xprd = prd[0]; @@ -95,78 +101,23 @@ void ComputeGrid::setup() dely = 1.0/delyinv; delz = 1.0/delzinv; - // sufficient conditions for stencil bounding rcut - - // require |delz*mz|^2 <= rcut^2 - // require |dely*my|^2 <= rcut^2 + |delyz*mz_max|^2 - // require |delx*mx|^2 <= rcut^2 + |delxz*mz_max|^2 + |delxy*my_max|^2 - - double delxy = domain->xy/ny; - double delxz = domain->xz/nz; - double delyz = domain->yz/nz; - - if (!triclinic) { - mz = cutmax*delzinv + 1; - my = sqrt(cutmax*cutmax + pow(delyz*mz,2))*delyinv + 1; - mx = sqrt(cutmax*cutmax + pow(delxz*mz,2) - + pow(delxy*my,2))*delxinv + 1; - } else { - double delxinvtmp = nx/domain->xprd; - double delyinvtmp = ny/domain->yprd; - double delzinvtmp = nz/domain->zprd; - mz = cutmax*delzinvtmp + 1; - my = sqrt(cutmax*cutmax + pow(delyz*mz,2))*delyinvtmp + 1; - mx = sqrt(cutmax*cutmax + pow(delxz*mz,2) - + pow(delxy*my,2))*delxinvtmp + 1; - } - - // size global grid to accomodate periodic interactions - - nxfull = nx + 2*mx; - nyfull = ny + 2*my; - nzfull = nz + 2*mz; - nxyfull = nxfull * nyfull; - - x0full = boxlo[0] - mx*delx; - y0full = boxlo[1] - my*dely; - z0full = boxlo[2] - mz*delz; - allocate(); - assign_coords_array(); + assign_grid_coords(); + assign_grid_local(); } /* ---------------------------------------------------------------------- - convert grid index to box coords + convert global array index to box coords ------------------------------------------------------------------------- */ -void ComputeGrid::igridfull2x(int igrid, double *x) +void ComputeGrid::grid2x(int igrid, double *x) { - int iz = igrid / nxyfull; - igrid -= iz * nxyfull; - int iy = igrid / nxfull; - igrid -= iy * nxfull; + int iz = igrid / (nx*ny); + igrid -= iz * (nx*ny); + int iy = igrid / nx; + igrid -= iy * nx; int ix = igrid; - x[0] = x0full+ix*delx; - x[1] = y0full+iy*dely; - x[2] = z0full+iz*delz; - - if (triclinic) domain->lamda2x(x, x); - -} - -/* ---------------------------------------------------------------------- - convert array index to box coords -------------------------------------------------------------------------- */ - -void ComputeGrid::iarray2x(int iarray, double *x) -{ - int iz = iarray / (nx*ny); - iarray -= iz * (nx*ny); - int iy = iarray / nx; - iarray -= iy * nx; - int ix = iarray; - x[0] = ix*delx; x[1] = iy*dely; x[2] = iz*delz; @@ -176,16 +127,43 @@ void ComputeGrid::iarray2x(int iarray, double *x) } /* ---------------------------------------------------------------------- - copy local grid to global array + check if grid point is local ------------------------------------------------------------------------- */ -void ComputeGrid::copy_local_grid() +int ComputeGrid::check_grid_local(int igrid) { - int igridfull; - for (int iarray = 0; iarray < size_array_rows; iarray++) { - igridfull = iarray2igridfull(iarray); - for (int icol = size_array_cols_base; icol < size_array_cols; icol++) - array[iarray][icol] = gridfull[igridfull][icol]; + double x[3]; + + int iz = igrid / (nx*ny); + igrid -= iz * (nx*ny); + int iy = igrid / nx; + igrid -= iy * nx; + int ix = igrid; + + x[0] = ix*delx; + x[1] = iy*dely; + x[2] = iz*delz; + + int islocal = + x[0] >= sublo[0] && x[0] < subhi[0] && + x[1] >= sublo[1] && x[1] < subhi[1] && + x[2] >= sublo[2] && x[2] < subhi[2]; + + return islocal; +} + +/* ---------------------------------------------------------------------- + copy coords to global array +------------------------------------------------------------------------- */ + +void ComputeGrid::assign_grid_coords() +{ + double x[3]; + for (int igrid = 0; igrid < ngrid; igrid++) { + grid2x(igrid,x); + grid[igrid][0] = x[0]; + grid[igrid][1] = x[1]; + grid[igrid][2] = x[2]; } } @@ -193,101 +171,33 @@ void ComputeGrid::copy_local_grid() copy coords to global array ------------------------------------------------------------------------- */ -void ComputeGrid::assign_coords_array() +void ComputeGrid::assign_grid_local() { double x[3]; - for (int iarray = 0; iarray < size_array_rows; iarray++) { - iarray2x(iarray,x); - array[iarray][0] = x[0]; - array[iarray][1] = x[1]; - array[iarray][2] = x[2]; + for (int igrid = 0; igrid < ngrid; igrid++) { + if (check_grid_local(igrid)) + grid_local[igrid] = 1; + else { + grid_local[igrid] = 0; + memset(grid[igrid],0,size_array_cols); + } } } -/* ---------------------------------------------------------------------- - gather global array from full grid -------------------------------------------------------------------------- */ - -void ComputeGrid::gather_global_array() -{ - int iarray; - memset(&array[0][0],0,size_array_rows*size_array_cols*sizeof(double)); - - for (int igrid = 0; igrid < ngridfull; igrid++) { - - // inefficient, should exploit shared ix structure - - iarray = igridfull2iarray(igrid); - for (int icol = size_array_cols_base; icol < size_array_cols; icol++) - array[iarray][icol] += gridfull[igrid][icol]; - } -} - -/* ---------------------------------------------------------------------- - convert full grid index to compute array index - inefficient, should exploit shared ix structure -------------------------------------------------------------------------- */ - -int ComputeGrid::igridfull2iarray(int igrid) -{ - int iz = igrid / nxyfull; - igrid -= iz*nxyfull; - int iy = igrid / nxfull; - igrid -= iy*nxfull; - int ix = igrid; - - ix -= mx; - iy -= my; - iz -= mz; - - while (ix < 0) ix += nx; - while (iy < 0) iy += ny; - while (iz < 0) iz += nz; - - while (ix >= nx) ix -= nx; - while (iy >= ny) iy -= ny; - while (iz >= nz) iz -= nz; - - int iarray = (iz * ny + iy) * nx + ix; - - return iarray; -} - -/* ---------------------------------------------------------------------- - convert compute array index to full grid index - inefficient, should exploit shared ix structure -------------------------------------------------------------------------- */ - -int ComputeGrid::iarray2igridfull(int iarray) -{ - int iz = iarray / (nx*ny); - iarray -= iz*(nx*ny); - int iy = iarray / nx; - iarray -= iy*nx; - int ix = iarray; - - ix += mx; - iy += my; - iz += mz; - - int igrid = (iz * nyfull + iy) * nxfull + ix; - - return igrid; -} - /* ---------------------------------------------------------------------- free and reallocate arrays ------------------------------------------------------------------------- */ void ComputeGrid::allocate() { - ngridfull = nxfull*nyfull*nzfull; - // grow global array if necessary - memory->destroy(array); - memory->create(array,size_array_rows,size_array_cols,"sna/grid:array"); - memory->create(gridfull,ngridfull,size_array_cols,"sna/grid:gridfull"); + memory->destroy(grid); + memory->destroy(grid_local); + memory->create(grid,size_array_rows,size_array_cols,"grid:grid"); + memory->create(gridall,size_array_rows,size_array_cols,"grid:gridall"); + memory->create(grid_local,size_array_rows,"grid:grid_local"); + array = gridall; } /* ---------------------------------------------------------------------- memory usage of local data @@ -295,6 +205,8 @@ void ComputeGrid::allocate() double ComputeGrid::memory_usage() { - int nbytes = 0; + double nbytes = size_array_rows*size_array_cols * + sizeof(double); // grid + nbytes += size_array_rows*sizeof(int); // grid_local return nbytes; } diff --git a/src/compute_grid.h b/src/compute_grid.h index 1468f9ad91..a1c938db2e 100644 --- a/src/compute_grid.h +++ b/src/compute_grid.h @@ -31,28 +31,24 @@ class ComputeGrid : public Compute { protected: int nx, ny, nz; // grid dimensions - int nxfull, nyfull, nzfull; // grid dimensions with ghost points - int nxyfull; // nx_full*ny_full - int ngridfull; // number of full grid points - double **gridfull; // full grid points - int mx, my, mz; // cutmax stencil dimensions + int ngrid; // number of grid points + int nvalues; // number of values per grid point + double **grid; // global grid + double **gridall; // global grid summed over procs int triclinic; // triclinic flag double *boxlo, *prd; // box info (units real/ortho or reduced/tri) + double *sublo, *subhi; // subdomain info (units real/ortho or reduced/tri) double delxinv,delyinv,delzinv; // inverse grid spacing double delx,dely,delz; // grid spacing - double x0full, y0full, z0full; // origin of full grid int nargbase; // number of base class args double cutmax; // largest cutoff distance int size_array_cols_base; // number of columns used for coords, etc. - virtual void allocate(); - void igridfull2x(int, double*); // convert full grid point to coord - void iarray2x(int, double*); // convert array point to coord - void gather_global_array(); // gather global array from full grid - void copy_local_grid(); // copy local grid to global array - void assign_coords_array(); // assign coords to global array - int igridfull2iarray(int); // convert full grid index to compute array index - int iarray2igridfull(int); // convert compute array index to full grid index - + int *grid_local; // local flag for each grid point + void allocate(); + void grid2x(int, double*); // convert grid point to coord + void assign_grid_coords(); // assign coords for grid + void assign_grid_local(); // set local flag for each grid point + int check_grid_local(int); // check if grid point is local private: }; From 651e9c63973809d1026faac942f84998dfe7ac74 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Tue, 19 May 2020 11:01:31 -0600 Subject: [PATCH 008/585] Initialized arrays to NULL --- src/compute_grid.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/compute_grid.cpp b/src/compute_grid.cpp index 2f67d22182..011dafa030 100644 --- a/src/compute_grid.cpp +++ b/src/compute_grid.cpp @@ -27,7 +27,7 @@ using namespace LAMMPS_NS; /* ---------------------------------------------------------------------- */ ComputeGrid::ComputeGrid(LAMMPS *lmp, int narg, char **arg) : - Compute(lmp, narg, arg) + Compute(lmp, narg, arg), grid(NULL), grid_local(NULL) { if (narg < 6) error->all(FLERR,"Illegal compute grid command"); From 4a261f396128a0d19beba082bd7f4ab6c54a1803 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Sat, 23 May 2020 10:18:16 -0600 Subject: [PATCH 009/585] Added python example (!) and turned on switching function --- examples/snap/grid.py | 104 +++++++++++++++++++++++++++++++++++ examples/snap/in.grid | 9 ++- examples/snap/in.grid.python | 61 ++++++++++++++++++++ examples/snap/in.grid.tri | 82 +++++++++++++-------------- 4 files changed, 214 insertions(+), 42 deletions(-) create mode 100755 examples/snap/grid.py create mode 100644 examples/snap/in.grid.python diff --git a/examples/snap/grid.py b/examples/snap/grid.py new file mode 100755 index 0000000000..9fe88fd1b4 --- /dev/null +++ b/examples/snap/grid.py @@ -0,0 +1,104 @@ +#!/Users/athomps/miniconda3/bin/python3.7 +# +# An example of SNAP grid from LAMMPS Python interface +# +# https://lammps.sandia.gov/doc/Python_library.html + + +from lammps import lammps +import lammps_utils + +# define command line input variables + +ngridx = 2 +ngridy = 3 +ngridz = 4 +twojmax = 2 + +lmp_cmdargs = ["-echo","screen"] +lmp_cmdargs = lammps_utils.set_cmdlinevars(lmp_cmdargs, + { + "ngridx":ngridx, + "ngridy":ngridy, + "ngridz":ngridz, + "twojmax":twojmax + } + ) + +# launch LAMMPS instance + +lmp = lammps(cmdargs=lmp_cmdargs) + +# run LAMMPS input script + +lmp.file("in.grid.python") + +# get quantities from LAMMPS + +num_atoms = lmp.get_natoms() + +# set things not accessible from LAMMPS + +# first 3 cols are x, y, z, coords + +ncols0 = 3 + +# analytical relation + +ncoeff = (twojmax+2)*(twojmax+3)*(twojmax+4) +ncoeff = ncoeff // 24 # integer division +ncols = ncols0+ncoeff + +# get B_0 at position (0,0,0) in 4 different ways + +# 1. from comute sna/atom + +bptr = lmp.extract_compute("b", 1, 2) # 1 = per-atom data, 2 = array +print("b = ",bptr[0][0]) + +# 2. from compute sna/grid + +bgridptr = lmp.extract_compute("bgrid", 0, 2) # 0 = style global, 2 = type array +print("bgrid = ",bgridptr[0][3]) + +# 3. from Numpy array pointing to sna/atom array + +bptr_np = lammps_utils.extract_compute_np(lmp,"b",1,2,(num_atoms,ncoeff)) +print("b_np = ",bptr_np[0][0]) + +# 4. from Numpy array pointing to sna/grid array + +bgridptr_np = lammps_utils.extract_compute_np(lmp,"bgrid",0,2,(ngridz,ngridy,ngridx,ncols)) +print("bgrid_np = ",bgridptr_np[0][0][0][ncols0+0]) + +# print out the LAMMPS array to a file + +outfile = open("bgrid.dat",'w') +igrid = 0 +for iz in range(ngridz): + for iy in range(ngridy): + for ix in range(ngridx): + outfile.write("x, y, z = %g %g %g\n" % + (bgridptr[igrid][0], + bgridptr[igrid][1], + bgridptr[igrid][2])) + for icoeff in range(ncoeff): + outfile.write("%g " % bgridptr[igrid][ncols0+icoeff]) + outfile.write("\n") + igrid += 1 +outfile.close() + +# print out the Numpy array to a file + +outfile = open("bgrid_np.dat",'w') +for iz in range(ngridz): + for iy in range(ngridy): + for ix in range(ngridx): + outfile.write("x, y, z = %g %g %g\n" % + (bgridptr_np[iz][iy][ix][0], + bgridptr_np[iz][iy][ix][1], + bgridptr_np[iz][iy][ix][2])) + for icoeff in range(ncoeff): + outfile.write("%g " % bgridptr_np[iz][iy][ix][ncols0+icoeff]) + outfile.write("\n") +outfile.close() diff --git a/examples/snap/in.grid b/examples/snap/in.grid index 5293558fab..2702fccad1 100644 --- a/examples/snap/in.grid +++ b/examples/snap/in.grid @@ -46,7 +46,7 @@ variable wj equal 1 variable radelem equal 0.5 variable bzero equal 0 variable quad equal 0 -variable switch equal 0 +variable switch equal 1 compute b all sna/atom & ${rcutfac} ${rfac0} ${twojmax} ${radelem} & @@ -60,11 +60,16 @@ compute mygrid all sna/grid grid ${ngrid} ${ngrid} ${ngrid} & # define output +# mygrid is ngrid by (3+nbis) = 8x8 thermo_style custom step temp ke pe vol & c_mygrid[1][1] c_mygrid[2][1] c_mygrid[3][1] c_mygrid[4][1] c_mygrid[5][1] c_mygrid[6][1] c_mygrid[7][1] c_mygrid[8][1] & c_mygrid[1][2] c_mygrid[2][2] c_mygrid[3][2] c_mygrid[4][2] c_mygrid[5][2] c_mygrid[6][2] c_mygrid[7][2] c_mygrid[8][2] & c_mygrid[1][3] c_mygrid[2][3] c_mygrid[3][3] c_mygrid[4][3] c_mygrid[5][3] c_mygrid[6][3] c_mygrid[7][3] c_mygrid[8][3] & - c_mygrid[1][4] c_mygrid[2][4] c_mygrid[3][4] c_mygrid[4][4] c_mygrid[5][4] c_mygrid[6][4] c_mygrid[7][4] c_mygrid[8][4] + c_mygrid[1][4] c_mygrid[2][4] c_mygrid[3][4] c_mygrid[4][4] c_mygrid[5][4] c_mygrid[6][4] c_mygrid[7][4] c_mygrid[8][4] & + c_mygrid[1][5] c_mygrid[2][5] c_mygrid[3][5] c_mygrid[4][5] c_mygrid[5][5] c_mygrid[6][5] c_mygrid[7][5] c_mygrid[8][5] & + c_mygrid[1][6] c_mygrid[2][6] c_mygrid[3][6] c_mygrid[4][6] c_mygrid[5][6] c_mygrid[6][6] c_mygrid[7][6] c_mygrid[8][6] & + c_mygrid[1][7] c_mygrid[2][7] c_mygrid[3][7] c_mygrid[4][7] c_mygrid[5][7] c_mygrid[6][7] c_mygrid[7][7] c_mygrid[8][7] & + c_mygrid[1][8] c_mygrid[2][8] c_mygrid[3][8] c_mygrid[4][8] c_mygrid[5][8] c_mygrid[6][8] c_mygrid[7][8] c_mygrid[8][8] thermo_modify norm yes dump mydump_b all custom 1000 dump_b id c_b[*] diff --git a/examples/snap/in.grid.python b/examples/snap/in.grid.python new file mode 100644 index 0000000000..13fe6d0638 --- /dev/null +++ b/examples/snap/in.grid.python @@ -0,0 +1,61 @@ +# Demonstrate bispectrum per-atom and grid computes + +# Invoked from grid.py +# pass in values for ngridx, ngridy, ngridz, twojmax + +# Initialize simulation + +variable nsteps equal 0 +variable nrep equal 1 +variable a equal 3.316 + +units metal + +# generate the box and atom positions using a BCC lattice + +variable nx equal ${nrep} +variable ny equal ${nrep} +variable nz equal ${nrep} + +boundary p p p + +lattice custom ${a} a1 1 0 0 a2 0 1 0 a3 0 0 1 basis 0 0 0 basis 0.5 0.5 0.5 + +region box block 0 ${nx} 0 ${ny} 0 ${nz} +create_box 1 box +create_atoms 1 box + +mass 1 180.88 + +# define grid compute and atom compute + +group snapgroup type 1 +variable rcutfac equal 4.67637 +variable rfac0 equal 0.99363 +variable rmin0 equal 0 +variable wj equal 1 +variable radelem equal 0.5 +variable bzero equal 0 +variable quad equal 0 +variable switch equal 1 + +compute b all sna/atom ${rcutfac} ${rfac0} ${twojmax} ${radelem} ${wj} rmin0 ${rmin0} bzeroflag ${bzero} quadraticflag ${quad} switchflag ${switch} + +compute bgrid all sna/grid grid ${ngridx} ${ngridy} ${ngridz} ${rcutfac} ${rfac0} ${twojmax} ${radelem} ${wj} rmin0 ${rmin0} bzeroflag ${bzero} quadraticflag ${quad} switchflag ${switch} + +# create dummy potential for neighbor list + +variable rcutneigh equal 2.0*${rcutfac}*${radelem} +pair_style zero ${rcutneigh} +pair_coeff * * + +# define output + +thermo_style custom step temp ke pe vol c_bgrid[1][1] +thermo_modify norm yes + +dump mydump_b all custom 1000 dump_b id c_b[*] + +# run + +run 0 diff --git a/examples/snap/in.grid.tri b/examples/snap/in.grid.tri index 3c471d9b66..c984799e09 100644 --- a/examples/snap/in.grid.tri +++ b/examples/snap/in.grid.tri @@ -51,7 +51,7 @@ variable wj equal 1 variable radelem equal 0.5 variable bzero equal 0 variable quad equal 0 -variable switch equal 0 +variable switch equal 1 compute b all sna/atom & ${rcutfac} ${rfac0} ${twojmax} ${radelem} & @@ -65,46 +65,48 @@ compute mygrid all sna/grid grid ${ngridx} ${ngridy} ${ngridz} & # define output +# mygrid is ngrid by (3+nbis) = 384x8 + thermo_style custom step temp ke pe vol & - c_mygrid[1][4] c_mygrid[2][4] c_mygrid[3][4] c_mygrid[4][4] c_mygrid[5][4] c_mygrid[6][4] c_mygrid[7][4] c_mygrid[8][4] c_mygrid[9][4] & - c_mygrid[10][4] c_mygrid[11][4] c_mygrid[12][4] c_mygrid[13][4] c_mygrid[14][4] c_mygrid[15][4] c_mygrid[16][4] c_mygrid[17][4] c_mygrid[18][4] c_mygrid[19][4] & - c_mygrid[20][4] c_mygrid[21][4] c_mygrid[22][4] c_mygrid[23][4] c_mygrid[24][4] c_mygrid[25][4] c_mygrid[26][4] c_mygrid[27][4] c_mygrid[28][4] c_mygrid[29][4] & - c_mygrid[30][4] c_mygrid[31][4] c_mygrid[32][4] c_mygrid[33][4] c_mygrid[34][4] c_mygrid[35][4] c_mygrid[36][4] c_mygrid[37][4] c_mygrid[38][4] c_mygrid[39][4] & - c_mygrid[40][4] c_mygrid[41][4] c_mygrid[42][4] c_mygrid[43][4] c_mygrid[44][4] c_mygrid[45][4] c_mygrid[46][4] c_mygrid[47][4] c_mygrid[48][4] c_mygrid[49][4] & - c_mygrid[50][4] c_mygrid[51][4] c_mygrid[52][4] c_mygrid[53][4] c_mygrid[54][4] c_mygrid[55][4] c_mygrid[56][4] c_mygrid[57][4] c_mygrid[58][4] c_mygrid[59][4] & - c_mygrid[60][4] c_mygrid[61][4] c_mygrid[62][4] c_mygrid[63][4] c_mygrid[64][4] c_mygrid[65][4] c_mygrid[66][4] c_mygrid[67][4] c_mygrid[68][4] c_mygrid[69][4] & - c_mygrid[70][4] c_mygrid[71][4] c_mygrid[72][4] c_mygrid[73][4] c_mygrid[74][4] c_mygrid[75][4] c_mygrid[76][4] c_mygrid[77][4] c_mygrid[78][4] c_mygrid[79][4] & - c_mygrid[80][4] c_mygrid[81][4] c_mygrid[82][4] c_mygrid[83][4] c_mygrid[84][4] c_mygrid[85][4] c_mygrid[86][4] c_mygrid[87][4] c_mygrid[88][4] c_mygrid[89][4] & - c_mygrid[90][4] c_mygrid[91][4] c_mygrid[92][4] c_mygrid[93][4] c_mygrid[94][4] c_mygrid[95][4] c_mygrid[96][4] c_mygrid[97][4] c_mygrid[98][4] c_mygrid[99][4] & - c_mygrid[101][4] c_mygrid[102][4] c_mygrid[103][4] c_mygrid[104][4] c_mygrid[105][4] c_mygrid[106][4] c_mygrid[107][4] c_mygrid[108][4] c_mygrid[109][4] & - c_mygrid[110][4] c_mygrid[111][4] c_mygrid[112][4] c_mygrid[113][4] c_mygrid[114][4] c_mygrid[115][4] c_mygrid[116][4] c_mygrid[117][4] c_mygrid[118][4] c_mygrid[119][4] & - c_mygrid[120][4] c_mygrid[121][4] c_mygrid[122][4] c_mygrid[123][4] c_mygrid[124][4] c_mygrid[125][4] c_mygrid[126][4] c_mygrid[127][4] c_mygrid[128][4] c_mygrid[129][4] & - c_mygrid[130][4] c_mygrid[131][4] c_mygrid[132][4] c_mygrid[133][4] c_mygrid[134][4] c_mygrid[135][4] c_mygrid[136][4] c_mygrid[137][4] c_mygrid[138][4] c_mygrid[139][4] & - c_mygrid[140][4] c_mygrid[141][4] c_mygrid[142][4] c_mygrid[143][4] c_mygrid[144][4] c_mygrid[145][4] c_mygrid[146][4] c_mygrid[147][4] c_mygrid[148][4] c_mygrid[149][4] & - c_mygrid[150][4] c_mygrid[151][4] c_mygrid[152][4] c_mygrid[153][4] c_mygrid[154][4] c_mygrid[155][4] c_mygrid[156][4] c_mygrid[157][4] c_mygrid[158][4] c_mygrid[159][4] & - c_mygrid[160][4] c_mygrid[161][4] c_mygrid[162][4] c_mygrid[163][4] c_mygrid[164][4] c_mygrid[165][4] c_mygrid[166][4] c_mygrid[167][4] c_mygrid[168][4] c_mygrid[169][4] & - c_mygrid[170][4] c_mygrid[171][4] c_mygrid[172][4] c_mygrid[173][4] c_mygrid[174][4] c_mygrid[175][4] c_mygrid[176][4] c_mygrid[177][4] c_mygrid[178][4] c_mygrid[179][4] & - c_mygrid[180][4] c_mygrid[181][4] c_mygrid[182][4] c_mygrid[183][4] c_mygrid[184][4] c_mygrid[185][4] c_mygrid[186][4] c_mygrid[187][4] c_mygrid[188][4] c_mygrid[189][4] & - c_mygrid[190][4] c_mygrid[191][4] c_mygrid[192][4] c_mygrid[193][4] c_mygrid[194][4] c_mygrid[195][4] c_mygrid[196][4] c_mygrid[197][4] c_mygrid[198][4] c_mygrid[199][4] & - c_mygrid[201][4] c_mygrid[202][4] c_mygrid[203][4] c_mygrid[204][4] c_mygrid[205][4] c_mygrid[206][4] c_mygrid[207][4] c_mygrid[208][4] c_mygrid[209][4] & - c_mygrid[210][4] c_mygrid[211][4] c_mygrid[212][4] c_mygrid[213][4] c_mygrid[214][4] c_mygrid[215][4] c_mygrid[216][4] c_mygrid[217][4] c_mygrid[218][4] c_mygrid[219][4] & - c_mygrid[220][4] c_mygrid[221][4] c_mygrid[222][4] c_mygrid[223][4] c_mygrid[224][4] c_mygrid[225][4] c_mygrid[226][4] c_mygrid[227][4] c_mygrid[228][4] c_mygrid[229][4] & - c_mygrid[230][4] c_mygrid[231][4] c_mygrid[232][4] c_mygrid[233][4] c_mygrid[234][4] c_mygrid[235][4] c_mygrid[236][4] c_mygrid[237][4] c_mygrid[238][4] c_mygrid[239][4] & - c_mygrid[240][4] c_mygrid[241][4] c_mygrid[242][4] c_mygrid[243][4] c_mygrid[244][4] c_mygrid[245][4] c_mygrid[246][4] c_mygrid[247][4] c_mygrid[248][4] c_mygrid[249][4] & - c_mygrid[250][4] c_mygrid[251][4] c_mygrid[252][4] c_mygrid[253][4] c_mygrid[254][4] c_mygrid[255][4] c_mygrid[256][4] c_mygrid[257][4] c_mygrid[258][4] c_mygrid[259][4] & - c_mygrid[260][4] c_mygrid[261][4] c_mygrid[262][4] c_mygrid[263][4] c_mygrid[264][4] c_mygrid[265][4] c_mygrid[266][4] c_mygrid[267][4] c_mygrid[268][4] c_mygrid[269][4] & - c_mygrid[270][4] c_mygrid[271][4] c_mygrid[272][4] c_mygrid[273][4] c_mygrid[274][4] c_mygrid[275][4] c_mygrid[276][4] c_mygrid[277][4] c_mygrid[278][4] c_mygrid[279][4] & - c_mygrid[280][4] c_mygrid[281][4] c_mygrid[282][4] c_mygrid[283][4] c_mygrid[284][4] c_mygrid[285][4] c_mygrid[286][4] c_mygrid[287][4] c_mygrid[288][4] c_mygrid[289][4] & - c_mygrid[290][4] c_mygrid[291][4] c_mygrid[292][4] c_mygrid[293][4] c_mygrid[294][4] c_mygrid[295][4] c_mygrid[296][4] c_mygrid[297][4] c_mygrid[298][4] c_mygrid[299][4] & - c_mygrid[301][4] c_mygrid[302][4] c_mygrid[303][4] c_mygrid[304][4] c_mygrid[305][4] c_mygrid[306][4] c_mygrid[307][4] c_mygrid[308][4] c_mygrid[309][4] & - c_mygrid[310][4] c_mygrid[311][4] c_mygrid[312][4] c_mygrid[313][4] c_mygrid[314][4] c_mygrid[315][4] c_mygrid[316][4] c_mygrid[317][4] c_mygrid[318][4] c_mygrid[319][4] & - c_mygrid[320][4] c_mygrid[321][4] c_mygrid[322][4] c_mygrid[323][4] c_mygrid[324][4] c_mygrid[325][4] c_mygrid[326][4] c_mygrid[327][4] c_mygrid[328][4] c_mygrid[329][4] & - c_mygrid[330][4] c_mygrid[331][4] c_mygrid[332][4] c_mygrid[333][4] c_mygrid[334][4] c_mygrid[335][4] c_mygrid[336][4] c_mygrid[337][4] c_mygrid[338][4] c_mygrid[339][4] & - c_mygrid[340][4] c_mygrid[341][4] c_mygrid[342][4] c_mygrid[343][4] c_mygrid[344][4] c_mygrid[345][4] c_mygrid[346][4] c_mygrid[347][4] c_mygrid[348][4] c_mygrid[349][4] & - c_mygrid[350][4] c_mygrid[351][4] c_mygrid[352][4] c_mygrid[353][4] c_mygrid[354][4] c_mygrid[355][4] c_mygrid[356][4] c_mygrid[357][4] c_mygrid[358][4] c_mygrid[359][4] & - c_mygrid[360][4] c_mygrid[361][4] c_mygrid[362][4] c_mygrid[363][4] c_mygrid[364][4] c_mygrid[365][4] c_mygrid[366][4] c_mygrid[367][4] c_mygrid[368][4] c_mygrid[369][4] & - c_mygrid[370][4] c_mygrid[371][4] c_mygrid[372][4] c_mygrid[373][4] c_mygrid[374][4] c_mygrid[375][4] c_mygrid[376][4] c_mygrid[377][4] c_mygrid[378][4] c_mygrid[379][4] & - c_mygrid[380][4] c_mygrid[381][4] c_mygrid[382][4] c_mygrid[383][4] c_mygrid[384][4] + c_mygrid[1][7] c_mygrid[2][7] c_mygrid[3][7] c_mygrid[4][7] c_mygrid[5][7] c_mygrid[6][7] c_mygrid[7][7] c_mygrid[8][7] c_mygrid[9][7] & + c_mygrid[10][7] c_mygrid[11][7] c_mygrid[12][7] c_mygrid[13][7] c_mygrid[14][7] c_mygrid[15][7] c_mygrid[16][7] c_mygrid[17][7] c_mygrid[18][7] c_mygrid[19][7] & + c_mygrid[20][7] c_mygrid[21][7] c_mygrid[22][7] c_mygrid[23][7] c_mygrid[24][7] c_mygrid[25][7] c_mygrid[26][7] c_mygrid[27][7] c_mygrid[28][7] c_mygrid[29][7] & + c_mygrid[30][7] c_mygrid[31][7] c_mygrid[32][7] c_mygrid[33][7] c_mygrid[34][7] c_mygrid[35][7] c_mygrid[36][7] c_mygrid[37][7] c_mygrid[38][7] c_mygrid[39][7] & + c_mygrid[40][7] c_mygrid[41][7] c_mygrid[42][7] c_mygrid[43][7] c_mygrid[44][7] c_mygrid[45][7] c_mygrid[46][7] c_mygrid[47][7] c_mygrid[48][7] c_mygrid[49][7] & + c_mygrid[50][7] c_mygrid[51][7] c_mygrid[52][7] c_mygrid[53][7] c_mygrid[54][7] c_mygrid[55][7] c_mygrid[56][7] c_mygrid[57][7] c_mygrid[58][7] c_mygrid[59][7] & + c_mygrid[60][7] c_mygrid[61][7] c_mygrid[62][7] c_mygrid[63][7] c_mygrid[64][7] c_mygrid[65][7] c_mygrid[66][7] c_mygrid[67][7] c_mygrid[68][7] c_mygrid[69][7] & + c_mygrid[70][7] c_mygrid[71][7] c_mygrid[72][7] c_mygrid[73][7] c_mygrid[74][7] c_mygrid[75][7] c_mygrid[76][7] c_mygrid[77][7] c_mygrid[78][7] c_mygrid[79][7] & + c_mygrid[80][7] c_mygrid[81][7] c_mygrid[82][7] c_mygrid[83][7] c_mygrid[84][7] c_mygrid[85][7] c_mygrid[86][7] c_mygrid[87][7] c_mygrid[88][7] c_mygrid[89][7] & + c_mygrid[90][7] c_mygrid[91][7] c_mygrid[92][7] c_mygrid[93][7] c_mygrid[94][7] c_mygrid[95][7] c_mygrid[96][7] c_mygrid[97][7] c_mygrid[98][7] c_mygrid[99][7] & + c_mygrid[101][7] c_mygrid[102][7] c_mygrid[103][7] c_mygrid[104][7] c_mygrid[105][7] c_mygrid[106][7] c_mygrid[107][7] c_mygrid[108][7] c_mygrid[109][7] & + c_mygrid[110][7] c_mygrid[111][7] c_mygrid[112][7] c_mygrid[113][7] c_mygrid[114][7] c_mygrid[115][7] c_mygrid[116][7] c_mygrid[117][7] c_mygrid[118][7] c_mygrid[119][7] & + c_mygrid[120][7] c_mygrid[121][7] c_mygrid[122][7] c_mygrid[123][7] c_mygrid[124][7] c_mygrid[125][7] c_mygrid[126][7] c_mygrid[127][7] c_mygrid[128][7] c_mygrid[129][7] & + c_mygrid[130][7] c_mygrid[131][7] c_mygrid[132][7] c_mygrid[133][7] c_mygrid[134][7] c_mygrid[135][7] c_mygrid[136][7] c_mygrid[137][7] c_mygrid[138][7] c_mygrid[139][7] & + c_mygrid[140][7] c_mygrid[141][7] c_mygrid[142][7] c_mygrid[143][7] c_mygrid[144][7] c_mygrid[145][7] c_mygrid[146][7] c_mygrid[147][7] c_mygrid[148][7] c_mygrid[149][7] & + c_mygrid[150][7] c_mygrid[151][7] c_mygrid[152][7] c_mygrid[153][7] c_mygrid[154][7] c_mygrid[155][7] c_mygrid[156][7] c_mygrid[157][7] c_mygrid[158][7] c_mygrid[159][7] & + c_mygrid[160][7] c_mygrid[161][7] c_mygrid[162][7] c_mygrid[163][7] c_mygrid[164][7] c_mygrid[165][7] c_mygrid[166][7] c_mygrid[167][7] c_mygrid[168][7] c_mygrid[169][7] & + c_mygrid[170][7] c_mygrid[171][7] c_mygrid[172][7] c_mygrid[173][7] c_mygrid[174][7] c_mygrid[175][7] c_mygrid[176][7] c_mygrid[177][7] c_mygrid[178][7] c_mygrid[179][7] & + c_mygrid[180][7] c_mygrid[181][7] c_mygrid[182][7] c_mygrid[183][7] c_mygrid[184][7] c_mygrid[185][7] c_mygrid[186][7] c_mygrid[187][7] c_mygrid[188][7] c_mygrid[189][7] & + c_mygrid[190][7] c_mygrid[191][7] c_mygrid[192][7] c_mygrid[193][7] c_mygrid[194][7] c_mygrid[195][7] c_mygrid[196][7] c_mygrid[197][7] c_mygrid[198][7] c_mygrid[199][7] & + c_mygrid[201][7] c_mygrid[202][7] c_mygrid[203][7] c_mygrid[204][7] c_mygrid[205][7] c_mygrid[206][7] c_mygrid[207][7] c_mygrid[208][7] c_mygrid[209][7] & + c_mygrid[210][7] c_mygrid[211][7] c_mygrid[212][7] c_mygrid[213][7] c_mygrid[214][7] c_mygrid[215][7] c_mygrid[216][7] c_mygrid[217][7] c_mygrid[218][7] c_mygrid[219][7] & + c_mygrid[220][7] c_mygrid[221][7] c_mygrid[222][7] c_mygrid[223][7] c_mygrid[224][7] c_mygrid[225][7] c_mygrid[226][7] c_mygrid[227][7] c_mygrid[228][7] c_mygrid[229][7] & + c_mygrid[230][7] c_mygrid[231][7] c_mygrid[232][7] c_mygrid[233][7] c_mygrid[234][7] c_mygrid[235][7] c_mygrid[236][7] c_mygrid[237][7] c_mygrid[238][7] c_mygrid[239][7] & + c_mygrid[240][7] c_mygrid[241][7] c_mygrid[242][7] c_mygrid[243][7] c_mygrid[244][7] c_mygrid[245][7] c_mygrid[246][7] c_mygrid[247][7] c_mygrid[248][7] c_mygrid[249][7] & + c_mygrid[250][7] c_mygrid[251][7] c_mygrid[252][7] c_mygrid[253][7] c_mygrid[254][7] c_mygrid[255][7] c_mygrid[256][7] c_mygrid[257][7] c_mygrid[258][7] c_mygrid[259][7] & + c_mygrid[260][7] c_mygrid[261][7] c_mygrid[262][7] c_mygrid[263][7] c_mygrid[264][7] c_mygrid[265][7] c_mygrid[266][7] c_mygrid[267][7] c_mygrid[268][7] c_mygrid[269][7] & + c_mygrid[270][7] c_mygrid[271][7] c_mygrid[272][7] c_mygrid[273][7] c_mygrid[274][7] c_mygrid[275][7] c_mygrid[276][7] c_mygrid[277][7] c_mygrid[278][7] c_mygrid[279][7] & + c_mygrid[280][7] c_mygrid[281][7] c_mygrid[282][7] c_mygrid[283][7] c_mygrid[284][7] c_mygrid[285][7] c_mygrid[286][7] c_mygrid[287][7] c_mygrid[288][7] c_mygrid[289][7] & + c_mygrid[290][7] c_mygrid[291][7] c_mygrid[292][7] c_mygrid[293][7] c_mygrid[294][7] c_mygrid[295][7] c_mygrid[296][7] c_mygrid[297][7] c_mygrid[298][7] c_mygrid[299][7] & + c_mygrid[301][7] c_mygrid[302][7] c_mygrid[303][7] c_mygrid[304][7] c_mygrid[305][7] c_mygrid[306][7] c_mygrid[307][7] c_mygrid[308][7] c_mygrid[309][7] & + c_mygrid[310][7] c_mygrid[311][7] c_mygrid[312][7] c_mygrid[313][7] c_mygrid[314][7] c_mygrid[315][7] c_mygrid[316][7] c_mygrid[317][7] c_mygrid[318][7] c_mygrid[319][7] & + c_mygrid[320][7] c_mygrid[321][7] c_mygrid[322][7] c_mygrid[323][7] c_mygrid[324][7] c_mygrid[325][7] c_mygrid[326][7] c_mygrid[327][7] c_mygrid[328][7] c_mygrid[329][7] & + c_mygrid[330][7] c_mygrid[331][7] c_mygrid[332][7] c_mygrid[333][7] c_mygrid[334][7] c_mygrid[335][7] c_mygrid[336][7] c_mygrid[337][7] c_mygrid[338][7] c_mygrid[339][7] & + c_mygrid[340][7] c_mygrid[341][7] c_mygrid[342][7] c_mygrid[343][7] c_mygrid[344][7] c_mygrid[345][7] c_mygrid[346][7] c_mygrid[347][7] c_mygrid[348][7] c_mygrid[349][7] & + c_mygrid[350][7] c_mygrid[351][7] c_mygrid[352][7] c_mygrid[353][7] c_mygrid[354][7] c_mygrid[355][7] c_mygrid[356][7] c_mygrid[357][7] c_mygrid[358][7] c_mygrid[359][7] & + c_mygrid[360][7] c_mygrid[361][7] c_mygrid[362][7] c_mygrid[363][7] c_mygrid[364][7] c_mygrid[365][7] c_mygrid[366][7] c_mygrid[367][7] c_mygrid[368][7] c_mygrid[369][7] & + c_mygrid[370][7] c_mygrid[371][7] c_mygrid[372][7] c_mygrid[373][7] c_mygrid[374][7] c_mygrid[375][7] c_mygrid[376][7] c_mygrid[377][7] c_mygrid[378][7] c_mygrid[379][7] & + c_mygrid[380][7] c_mygrid[381][7] c_mygrid[382][7] c_mygrid[383][7] c_mygrid[384][7] thermo_modify norm yes From 4bfb5051237421cdef4501f9a3edb23f52589629 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Mon, 25 May 2020 16:35:50 -0600 Subject: [PATCH 010/585] Added reviewer response doc --- src/ReviewerResponse.tex | 59 ++++++++++++++++++++++++++++++++++++++++ 1 file changed, 59 insertions(+) create mode 100644 src/ReviewerResponse.tex diff --git a/src/ReviewerResponse.tex b/src/ReviewerResponse.tex new file mode 100644 index 0000000000..e29d756d78 --- /dev/null +++ b/src/ReviewerResponse.tex @@ -0,0 +1,59 @@ +\pdfoutput=1 +\documentclass[onecolumn,prb,showpacs,aps,superscriptaddress]{revtex4-1} +%\documentclass[prb,showpacs,aps,superscriptaddress]{revtex4-1} + + +\usepackage[english]{babel} +\usepackage[ansinew]{inputenc} +\usepackage{times} +\usepackage{graphicx} +\usepackage{graphics} +\usepackage{amsmath} +\usepackage{amsfonts} +\usepackage{amssymb} +\usepackage{amsbsy} +\usepackage{dsfont} +\usepackage{epstopdf} +\usepackage{makeidx} +%\usepackage{subfigure} +\usepackage{color} +\usepackage{pgf} +\usepackage{bm} +\usepackage{tikz} +%\usepackage[normalem]{ulem} +\usepackage{graphicx} % needed for figures +\usepackage{dcolumn} % needed for some tables +\usepackage{bm} % for math +\usepackage{amssymb} % for math + + +\begin{document} + +{\bf Title Here} + + +\vspace{1cm} + +We thank the reviewers for their careful reading of the manuscript and their suggestions for improvement. We have updated the manuscript accordingly. Please see below for our detailed responses to the review comments. + +\vspace{2cm} + + +\textbf{\underline{Reviewer 1:}} +\begin{itemize} + \item \textbf{Review Comment 1:} Blah blah + \item \textbf{Author Reply 1:} Thank you for your review. We agree making the blha blah is a good idea. We added the following sentence to the Conclusions to address this point \\ + ``Blah blah'' + +\end{itemize} + +\textbf{\underline{Reviewer 2:}} +\begin{itemize} + \item \textbf{Review Comment 1:} Blah blah + \item \textbf{Author Reply 1:} Blah blah \\ + +\end{itemize} + +\end{document} + + From 4295dd2dbcc9aae860607e823c440169c1cc23ae Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Mon, 25 May 2020 17:09:32 -0600 Subject: [PATCH 011/585] Wrong number --- src/ReviewerResponse.tex | 59 ---------------------------------------- 1 file changed, 59 deletions(-) delete mode 100644 src/ReviewerResponse.tex diff --git a/src/ReviewerResponse.tex b/src/ReviewerResponse.tex deleted file mode 100644 index e29d756d78..0000000000 --- a/src/ReviewerResponse.tex +++ /dev/null @@ -1,59 +0,0 @@ -\pdfoutput=1 -\documentclass[onecolumn,prb,showpacs,aps,superscriptaddress]{revtex4-1} -%\documentclass[prb,showpacs,aps,superscriptaddress]{revtex4-1} - - -\usepackage[english]{babel} -\usepackage[ansinew]{inputenc} -\usepackage{times} -\usepackage{graphicx} -\usepackage{graphics} -\usepackage{amsmath} -\usepackage{amsfonts} -\usepackage{amssymb} -\usepackage{amsbsy} -\usepackage{dsfont} -\usepackage{epstopdf} -\usepackage{makeidx} -%\usepackage{subfigure} -\usepackage{color} -\usepackage{pgf} -\usepackage{bm} -\usepackage{tikz} -%\usepackage[normalem]{ulem} -\usepackage{graphicx} % needed for figures -\usepackage{dcolumn} % needed for some tables -\usepackage{bm} % for math -\usepackage{amssymb} % for math - - -\begin{document} - -{\bf Title Here} - - -\vspace{1cm} - -We thank the reviewers for their careful reading of the manuscript and their suggestions for improvement. We have updated the manuscript accordingly. Please see below for our detailed responses to the review comments. - -\vspace{2cm} - - -\textbf{\underline{Reviewer 1:}} -\begin{itemize} - \item \textbf{Review Comment 1:} Blah blah - \item \textbf{Author Reply 1:} Thank you for your review. We agree making the blha blah is a good idea. We added the following sentence to the Conclusions to address this point \\ - ``Blah blah'' - -\end{itemize} - -\textbf{\underline{Reviewer 2:}} -\begin{itemize} - \item \textbf{Review Comment 1:} Blah blah - \item \textbf{Author Reply 1:} Blah blah \\ - -\end{itemize} - -\end{document} - - From cf6570d81283a356915bd4379ca807837988ccc9 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Fri, 2 Jul 2021 15:06:19 -0600 Subject: [PATCH 012/585] Tweaked comments in grid examples --- examples/snap/in.grid | 3 +++ examples/snap/in.grid.tri | 26 ++++++++++++++++++++------ 2 files changed, 23 insertions(+), 6 deletions(-) diff --git a/examples/snap/in.grid b/examples/snap/in.grid index 2702fccad1..44c42673e0 100644 --- a/examples/snap/in.grid +++ b/examples/snap/in.grid @@ -1,5 +1,8 @@ # Demonstrate bispectrum computes +# CORRECTNESS: thermo output for c_mygrid[*][1] and c_mygrid[*][8] should +# match the values in dump_b: 108.173 3.21778 0.712238 7.06634 1.04273 + # Initialize simulation variable nsteps index 0 diff --git a/examples/snap/in.grid.tri b/examples/snap/in.grid.tri index c984799e09..fc71c3a43f 100644 --- a/examples/snap/in.grid.tri +++ b/examples/snap/in.grid.tri @@ -1,5 +1,15 @@ # Demonstrate bispectrum computes +# This triclinic cell has 6 times the volume of a single bcc cube +# and contains 12 atoms. It is a 3x2x1 supercell +# with each unit cell containing 2 atoms and the +# reduced lattice vectors are [1 0 0], [1 1 0], and [1 1 1]. +# The grid is listed in x-fastest order +# CORRECTNESS: thermo output for c_mygrid[*][7] should contain +# the same 2 values that appear in c_mygrid[*][7] for in.grid, +# 7.0663376 and 13.808803, corresponding to atom and insterstitial sites, +# respectively, and with occurrences 12 and 36, respectively. + # Initialize simulation variable nsteps index 0 @@ -11,13 +21,17 @@ variable ngridx equal 3*${ngrid} variable ngridy equal 2*${ngrid} variable ngridz equal 1*${ngrid} +variable nrepx equal 1*${nrep} +variable nrepy equal 1*${nrep} +variable nrepz equal 1*${nrep} + units metal # generate the box and atom positions using a BCC lattice -variable nx equal ${nrep} -variable ny equal ${nrep} -variable nz equal ${nrep} +variable nx equal ${nrepx} +variable ny equal ${nrepy} +variable nz equal ${nrepz} boundary p p p @@ -78,7 +92,7 @@ thermo_style custom step temp ke pe vol & c_mygrid[70][7] c_mygrid[71][7] c_mygrid[72][7] c_mygrid[73][7] c_mygrid[74][7] c_mygrid[75][7] c_mygrid[76][7] c_mygrid[77][7] c_mygrid[78][7] c_mygrid[79][7] & c_mygrid[80][7] c_mygrid[81][7] c_mygrid[82][7] c_mygrid[83][7] c_mygrid[84][7] c_mygrid[85][7] c_mygrid[86][7] c_mygrid[87][7] c_mygrid[88][7] c_mygrid[89][7] & c_mygrid[90][7] c_mygrid[91][7] c_mygrid[92][7] c_mygrid[93][7] c_mygrid[94][7] c_mygrid[95][7] c_mygrid[96][7] c_mygrid[97][7] c_mygrid[98][7] c_mygrid[99][7] & - c_mygrid[101][7] c_mygrid[102][7] c_mygrid[103][7] c_mygrid[104][7] c_mygrid[105][7] c_mygrid[106][7] c_mygrid[107][7] c_mygrid[108][7] c_mygrid[109][7] & + c_mygrid[100][7] c_mygrid[101][7] c_mygrid[102][7] c_mygrid[103][7] c_mygrid[104][7] c_mygrid[105][7] c_mygrid[106][7] c_mygrid[107][7] c_mygrid[108][7] c_mygrid[109][7] & c_mygrid[110][7] c_mygrid[111][7] c_mygrid[112][7] c_mygrid[113][7] c_mygrid[114][7] c_mygrid[115][7] c_mygrid[116][7] c_mygrid[117][7] c_mygrid[118][7] c_mygrid[119][7] & c_mygrid[120][7] c_mygrid[121][7] c_mygrid[122][7] c_mygrid[123][7] c_mygrid[124][7] c_mygrid[125][7] c_mygrid[126][7] c_mygrid[127][7] c_mygrid[128][7] c_mygrid[129][7] & c_mygrid[130][7] c_mygrid[131][7] c_mygrid[132][7] c_mygrid[133][7] c_mygrid[134][7] c_mygrid[135][7] c_mygrid[136][7] c_mygrid[137][7] c_mygrid[138][7] c_mygrid[139][7] & @@ -88,7 +102,7 @@ thermo_style custom step temp ke pe vol & c_mygrid[170][7] c_mygrid[171][7] c_mygrid[172][7] c_mygrid[173][7] c_mygrid[174][7] c_mygrid[175][7] c_mygrid[176][7] c_mygrid[177][7] c_mygrid[178][7] c_mygrid[179][7] & c_mygrid[180][7] c_mygrid[181][7] c_mygrid[182][7] c_mygrid[183][7] c_mygrid[184][7] c_mygrid[185][7] c_mygrid[186][7] c_mygrid[187][7] c_mygrid[188][7] c_mygrid[189][7] & c_mygrid[190][7] c_mygrid[191][7] c_mygrid[192][7] c_mygrid[193][7] c_mygrid[194][7] c_mygrid[195][7] c_mygrid[196][7] c_mygrid[197][7] c_mygrid[198][7] c_mygrid[199][7] & - c_mygrid[201][7] c_mygrid[202][7] c_mygrid[203][7] c_mygrid[204][7] c_mygrid[205][7] c_mygrid[206][7] c_mygrid[207][7] c_mygrid[208][7] c_mygrid[209][7] & + c_mygrid[200][7] c_mygrid[201][7] c_mygrid[202][7] c_mygrid[203][7] c_mygrid[204][7] c_mygrid[205][7] c_mygrid[206][7] c_mygrid[207][7] c_mygrid[208][7] c_mygrid[209][7] & c_mygrid[210][7] c_mygrid[211][7] c_mygrid[212][7] c_mygrid[213][7] c_mygrid[214][7] c_mygrid[215][7] c_mygrid[216][7] c_mygrid[217][7] c_mygrid[218][7] c_mygrid[219][7] & c_mygrid[220][7] c_mygrid[221][7] c_mygrid[222][7] c_mygrid[223][7] c_mygrid[224][7] c_mygrid[225][7] c_mygrid[226][7] c_mygrid[227][7] c_mygrid[228][7] c_mygrid[229][7] & c_mygrid[230][7] c_mygrid[231][7] c_mygrid[232][7] c_mygrid[233][7] c_mygrid[234][7] c_mygrid[235][7] c_mygrid[236][7] c_mygrid[237][7] c_mygrid[238][7] c_mygrid[239][7] & @@ -98,7 +112,7 @@ thermo_style custom step temp ke pe vol & c_mygrid[270][7] c_mygrid[271][7] c_mygrid[272][7] c_mygrid[273][7] c_mygrid[274][7] c_mygrid[275][7] c_mygrid[276][7] c_mygrid[277][7] c_mygrid[278][7] c_mygrid[279][7] & c_mygrid[280][7] c_mygrid[281][7] c_mygrid[282][7] c_mygrid[283][7] c_mygrid[284][7] c_mygrid[285][7] c_mygrid[286][7] c_mygrid[287][7] c_mygrid[288][7] c_mygrid[289][7] & c_mygrid[290][7] c_mygrid[291][7] c_mygrid[292][7] c_mygrid[293][7] c_mygrid[294][7] c_mygrid[295][7] c_mygrid[296][7] c_mygrid[297][7] c_mygrid[298][7] c_mygrid[299][7] & - c_mygrid[301][7] c_mygrid[302][7] c_mygrid[303][7] c_mygrid[304][7] c_mygrid[305][7] c_mygrid[306][7] c_mygrid[307][7] c_mygrid[308][7] c_mygrid[309][7] & + c_mygrid[300][7] c_mygrid[301][7] c_mygrid[302][7] c_mygrid[303][7] c_mygrid[304][7] c_mygrid[305][7] c_mygrid[306][7] c_mygrid[307][7] c_mygrid[308][7] c_mygrid[309][7] & c_mygrid[310][7] c_mygrid[311][7] c_mygrid[312][7] c_mygrid[313][7] c_mygrid[314][7] c_mygrid[315][7] c_mygrid[316][7] c_mygrid[317][7] c_mygrid[318][7] c_mygrid[319][7] & c_mygrid[320][7] c_mygrid[321][7] c_mygrid[322][7] c_mygrid[323][7] c_mygrid[324][7] c_mygrid[325][7] c_mygrid[326][7] c_mygrid[327][7] c_mygrid[328][7] c_mygrid[329][7] & c_mygrid[330][7] c_mygrid[331][7] c_mygrid[332][7] c_mygrid[333][7] c_mygrid[334][7] c_mygrid[335][7] c_mygrid[336][7] c_mygrid[337][7] c_mygrid[338][7] c_mygrid[339][7] & From 442585313c4e8c9ba03419987a44266412acaa33 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Fri, 2 Jul 2021 15:11:14 -0600 Subject: [PATCH 013/585] Test --- examples/snap/in.grid.tri | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/examples/snap/in.grid.tri b/examples/snap/in.grid.tri index fc71c3a43f..da87774107 100644 --- a/examples/snap/in.grid.tri +++ b/examples/snap/in.grid.tri @@ -1,4 +1,4 @@ -# Demonstrate bispectrum computes +# Demonstrate bispectrum computes for triclinic cell # This triclinic cell has 6 times the volume of a single bcc cube # and contains 12 atoms. It is a 3x2x1 supercell From e102864c2dd9bf56b9a87808e98ac9b7042cff41 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Fri, 2 Jul 2021 15:13:40 -0600 Subject: [PATCH 014/585] Test2 --- examples/snap/in.grid.tri | 3 ++- 1 file changed, 2 insertions(+), 1 deletion(-) diff --git a/examples/snap/in.grid.tri b/examples/snap/in.grid.tri index da87774107..a5b2453c3b 100644 --- a/examples/snap/in.grid.tri +++ b/examples/snap/in.grid.tri @@ -1,6 +1,7 @@ # Demonstrate bispectrum computes for triclinic cell -# This triclinic cell has 6 times the volume of a single bcc cube +# This triclinic cell has 6 times the volume of the single +# unit cell used by in.grid # and contains 12 atoms. It is a 3x2x1 supercell # with each unit cell containing 2 atoms and the # reduced lattice vectors are [1 0 0], [1 1 0], and [1 1 1]. From 01475cb3a84005ddde51411c97c4f5f1eb353d71 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Fri, 2 Jul 2021 15:35:59 -0600 Subject: [PATCH 015/585] Test3 --- examples/snap/in.grid.tri | 1 + 1 file changed, 1 insertion(+) diff --git a/examples/snap/in.grid.tri b/examples/snap/in.grid.tri index a5b2453c3b..201f763eeb 100644 --- a/examples/snap/in.grid.tri +++ b/examples/snap/in.grid.tri @@ -131,3 +131,4 @@ dump mydump_b all custom 1000 dump_b id c_b[*] run 0 + From 39039d261f39966bad202ded3c5244065f323aa3 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Fri, 2 Jul 2021 15:37:49 -0600 Subject: [PATCH 016/585] Test6 --- examples/snap/in.grid.tri | 1 + 1 file changed, 1 insertion(+) diff --git a/examples/snap/in.grid.tri b/examples/snap/in.grid.tri index 201f763eeb..f375c18c42 100644 --- a/examples/snap/in.grid.tri +++ b/examples/snap/in.grid.tri @@ -132,3 +132,4 @@ dump mydump_b all custom 1000 dump_b id c_b[*] run 0 + From e17ace385ddc6d00a485c1c8fd04989526462d6f Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Fri, 2 Jul 2021 17:47:45 -0600 Subject: [PATCH 017/585] First pass at distributed memory for grid --- src/SNAP/compute_sna_grid.cpp | 93 +++++++------- src/compute_grid.cpp | 224 ++++++++++++++++++++-------------- src/compute_grid.h | 17 ++- 3 files changed, 194 insertions(+), 140 deletions(-) diff --git a/src/SNAP/compute_sna_grid.cpp b/src/SNAP/compute_sna_grid.cpp index a9f3b6c3fb..196819008c 100644 --- a/src/SNAP/compute_sna_grid.cpp +++ b/src/SNAP/compute_sna_grid.cpp @@ -182,66 +182,75 @@ void ComputeSNAGrid::compute_array() snaptr->grow_rij(ntotal); - printf("ngrid = %d\n",ngrid); - for (int igrid = 0; igrid < ngrid; igrid++) { - if (!grid_local[igrid]) continue; - const double xtmp = grid[igrid][0]; - const double ytmp = grid[igrid][1]; - const double ztmp = grid[igrid][2]; + for (int iz = nzlo; iz <= nzhi; iz++) + for (int iy = nylo; iy <= nyhi; iy++) + for (int ix = nxlo; ix <= nxhi; ix++) { + const int igrid = iz*(nx*ny) + iy*nx + ix; + const double xtmp = grid[igrid][0]; + const double ytmp = grid[igrid][1]; + const double ztmp = grid[igrid][2]; - // rij[][3] = displacements between atom I and those neighbors - // inside = indices of neighbors of I within cutoff - // typej = types of neighbors of I within cutoff + // rij[][3] = displacements between atom I and those neighbors + // inside = indices of neighbors of I within cutoff + // typej = types of neighbors of I within cutoff - int ninside = 0; - for (int j = 0; j < ntotal; j++) { + int ninside = 0; + for (int j = 0; j < ntotal; j++) { - // check that j is in compute group + // check that j is in compute group - if (!(mask[j] & groupbit)) continue; + if (!(mask[j] & groupbit)) continue; - const double delx = xtmp - x[j][0]; - const double dely = ytmp - x[j][1]; - const double delz = ztmp - x[j][2]; - const double rsq = delx*delx + dely*dely + delz*delz; - int jtype = type[j]; - if (rsq < cutsq[jtype][jtype] && rsq>1e-20) { - // printf("ninside = %d\n",ninside); - snaptr->rij[ninside][0] = delx; - snaptr->rij[ninside][1] = dely; - snaptr->rij[ninside][2] = delz; - snaptr->inside[ninside] = j; - snaptr->wj[ninside] = wjelem[jtype]; - snaptr->rcutij[ninside] = 2.0*radelem[jtype]*rcutfac; - ninside++; - } - } + const double delx = xtmp - x[j][0]; + const double dely = ytmp - x[j][1]; + const double delz = ztmp - x[j][2]; + const double rsq = delx*delx + dely*dely + delz*delz; + int jtype = type[j]; + if (rsq < cutsq[jtype][jtype] && rsq>1e-20) { + snaptr->rij[ninside][0] = delx; + snaptr->rij[ninside][1] = dely; + snaptr->rij[ninside][2] = delz; + snaptr->inside[ninside] = j; + snaptr->wj[ninside] = wjelem[jtype]; + snaptr->rcutij[ninside] = 2.0*radelem[jtype]*rcutfac; + ninside++; + } + } - snaptr->compute_ui(ninside); - snaptr->compute_zi(); - snaptr->compute_bi(); - for (int icoeff = 0; icoeff < ncoeff; icoeff++) - grid[igrid][size_array_cols_base+icoeff] = snaptr->blist[icoeff]; - // printf("igrid = %d %g %g %g %d B0 = %g\n",igrid,xtmp,ytmp,ztmp,ninside,sna[igrid][size_array_cols_base+0]); - if (quadraticflag) { - int ncount = ncoeff; - for (int icoeff = 0; icoeff < ncoeff; icoeff++) { - double bi = snaptr->blist[icoeff]; + snaptr->compute_ui(ninside); + snaptr->compute_zi(); + snaptr->compute_bi(); + for (int icoeff = 0; icoeff < ncoeff; icoeff++) + gridlocal[size_array_cols_base+icoeff][iz][iy][ix] = snaptr->blist[icoeff]; + if (quadraticflag) { + int ncount = ncoeff; + for (int icoeff = 0; icoeff < ncoeff; icoeff++) { + double bi = snaptr->blist[icoeff]; - // diagonal element of quadratic matrix + // diagonal element of quadratic matrix - grid[igrid][size_array_cols_base+ncount++] = 0.5*bi*bi; + gridlocal[size_array_cols_base+ncount++][iz][iy][ix] = 0.5*bi*bi; // upper-triangular elements of quadratic matrix for (int jcoeff = icoeff+1; jcoeff < ncoeff; jcoeff++) - grid[igrid][size_array_cols_base+ncount++] = bi*snaptr->blist[jcoeff]; + gridlocal[size_array_cols_base+ncount++][iz][iy][ix] = bi*snaptr->blist[jcoeff]; } } } + + for (int iz = nzlo; iz <= nzhi; iz++) + for (int iy = nylo; iy <= nyhi; iy++) + for (int ix = nxlo; ix <= nxhi; ix++) { + const int igrid = iz*(nx*ny) + iy*nx + ix; + for (int j = 0; j < nvalues; j++) + grid[igrid][size_array_cols_base + j] = gridlocal[size_array_cols_base + j][iz][iy][ix]; + } MPI_Allreduce(&grid[0][0],&gridall[0][0],ngrid*size_array_cols,MPI_DOUBLE,MPI_SUM,world); + } + /* ---------------------------------------------------------------------- memory usage ------------------------------------------------------------------------- */ diff --git a/src/compute_grid.cpp b/src/compute_grid.cpp index 011dafa030..b16a51b739 100644 --- a/src/compute_grid.cpp +++ b/src/compute_grid.cpp @@ -21,13 +21,14 @@ #include "force.h" #include "memory.h" #include "error.h" +#include "comm.h" using namespace LAMMPS_NS; /* ---------------------------------------------------------------------- */ ComputeGrid::ComputeGrid(LAMMPS *lmp, int narg, char **arg) : - Compute(lmp, narg, arg), grid(NULL), grid_local(NULL) + Compute(lmp, narg, arg), grid(NULL), local_flags(NULL), gridlocal(NULL) { if (narg < 6) error->all(FLERR,"Illegal compute grid command"); @@ -59,7 +60,8 @@ ComputeGrid::ComputeGrid(LAMMPS *lmp, int narg, char **arg) : ComputeGrid::~ComputeGrid() { memory->destroy(grid); - memory->destroy(grid_local); + memory->destroy(local_flags); + memory->destroy4d_offset(gridlocal,nzlo,nylo,nxlo); } /* ---------------------------------------------------------------------- */ @@ -72,7 +74,118 @@ void ComputeGrid::init() void ComputeGrid::setup() { - + + set_grid_global(); + set_grid_local(); + allocate(); + assign_coords(); + assign_local_flags(); +} + +/* ---------------------------------------------------------------------- + convert global array index to box coords +------------------------------------------------------------------------- */ + +void ComputeGrid::grid2x(int igrid, double *x) +{ + int iz = igrid / (nx*ny); + igrid -= iz * (nx*ny); + int iy = igrid / nx; + igrid -= iy * nx; + int ix = igrid; + + x[0] = ix*delx; + x[1] = iy*dely; + x[2] = iz*delz; + + if (triclinic) domain->lamda2x(x, x); + +} + +/* ---------------------------------------------------------------------- + check if grid point is local +------------------------------------------------------------------------- */ + +int ComputeGrid::check_local(int igrid) +{ + double x[3]; + + int iz = igrid / (nx*ny); + igrid -= iz * (nx*ny); + int iy = igrid / nx; + igrid -= iy * nx; + int ix = igrid; + + x[0] = ix*delx; + x[1] = iy*dely; + x[2] = iz*delz; + + int islocal = + x[0] >= sublo[0] && x[0] < subhi[0] && + x[1] >= sublo[1] && x[1] < subhi[1] && + x[2] >= sublo[2] && x[2] < subhi[2]; + + return islocal; +} + +/* ---------------------------------------------------------------------- + copy coords to global array +------------------------------------------------------------------------- */ + +void ComputeGrid::assign_coords() +{ + double x[3]; + for (int igrid = 0; igrid < ngrid; igrid++) { + grid2x(igrid,x); + grid[igrid][0] = x[0]; + grid[igrid][1] = x[1]; + grid[igrid][2] = x[2]; + } +} + +/* ---------------------------------------------------------------------- + copy coords to global array +------------------------------------------------------------------------- */ + +void ComputeGrid::assign_local_flags() +{ + double x[3]; + for (int igrid = 0; igrid < ngrid; igrid++) { + if (check_local(igrid)) + local_flags[igrid] = 1; + else { + local_flags[igrid] = 0; + memset(grid[igrid],0,size_array_cols); + } + } +} + +/* ---------------------------------------------------------------------- + free and reallocate arrays +------------------------------------------------------------------------- */ + +void ComputeGrid::allocate() +{ + // allocate arrays + + memory->destroy(grid); + memory->destroy(local_flags); + memory->destroy4d_offset(gridlocal,nzlo,nylo,nxlo); + memory->create(grid,size_array_rows,size_array_cols,"grid:grid"); + memory->create(gridall,size_array_rows,size_array_cols,"grid:gridall"); + memory->create(local_flags,size_array_rows,"grid:local_flags"); + memory->create4d_offset(gridlocal,size_array_cols,nzlo,nzhi,nylo,nyhi, + nxlo,nxhi,"grid:gridlocal"); + array = gridall; +} + + +/* ---------------------------------------------------------------------- + set global grid +------------------------------------------------------------------------- */ + +void ComputeGrid::set_grid_global() +{ // calculate grid layout triclinic = domain->triclinic; @@ -100,105 +213,31 @@ void ComputeGrid::setup() delx = 1.0/delxinv; dely = 1.0/delyinv; delz = 1.0/delzinv; - - allocate(); - assign_grid_coords(); - assign_grid_local(); } /* ---------------------------------------------------------------------- - convert global array index to box coords + set local subset of grid that I own + n xyz lo/hi = 3d brick that I own (inclusive) ------------------------------------------------------------------------- */ -void ComputeGrid::grid2x(int igrid, double *x) +void ComputeGrid::set_grid_local() { - int iz = igrid / (nx*ny); - igrid -= iz * (nx*ny); - int iy = igrid / nx; - igrid -= iy * nx; - int ix = igrid; + // global indices of grid range from 0 to N-1 + // nlo,nhi = lower/upper limits of the 3d sub-brick of + // global grid that I own without ghost cells - x[0] = ix*delx; - x[1] = iy*dely; - x[2] = iz*delz; + nxlo = static_cast (comm->xsplit[comm->myloc[0]] * nx); + nxhi = static_cast (comm->xsplit[comm->myloc[0]+1] * nx) - 1; - if (triclinic) domain->lamda2x(x, x); + nylo = static_cast (comm->ysplit[comm->myloc[1]] * ny); + nyhi = static_cast (comm->ysplit[comm->myloc[1]+1] * ny) - 1; + nzlo = static_cast (comm->zsplit[comm->myloc[2]] * nz); + nzhi = static_cast (comm->zsplit[comm->myloc[2]+1] * nz) - 1; + + ngridlocal = (nxhi - nxlo + 1) * (nyhi - nylo + 1) * (nzhi - nzlo + 1); } -/* ---------------------------------------------------------------------- - check if grid point is local -------------------------------------------------------------------------- */ - -int ComputeGrid::check_grid_local(int igrid) -{ - double x[3]; - - int iz = igrid / (nx*ny); - igrid -= iz * (nx*ny); - int iy = igrid / nx; - igrid -= iy * nx; - int ix = igrid; - - x[0] = ix*delx; - x[1] = iy*dely; - x[2] = iz*delz; - - int islocal = - x[0] >= sublo[0] && x[0] < subhi[0] && - x[1] >= sublo[1] && x[1] < subhi[1] && - x[2] >= sublo[2] && x[2] < subhi[2]; - - return islocal; -} - -/* ---------------------------------------------------------------------- - copy coords to global array -------------------------------------------------------------------------- */ - -void ComputeGrid::assign_grid_coords() -{ - double x[3]; - for (int igrid = 0; igrid < ngrid; igrid++) { - grid2x(igrid,x); - grid[igrid][0] = x[0]; - grid[igrid][1] = x[1]; - grid[igrid][2] = x[2]; - } -} - -/* ---------------------------------------------------------------------- - copy coords to global array -------------------------------------------------------------------------- */ - -void ComputeGrid::assign_grid_local() -{ - double x[3]; - for (int igrid = 0; igrid < ngrid; igrid++) { - if (check_grid_local(igrid)) - grid_local[igrid] = 1; - else { - grid_local[igrid] = 0; - memset(grid[igrid],0,size_array_cols); - } - } -} - -/* ---------------------------------------------------------------------- - free and reallocate arrays -------------------------------------------------------------------------- */ - -void ComputeGrid::allocate() -{ - // grow global array if necessary - - memory->destroy(grid); - memory->destroy(grid_local); - memory->create(grid,size_array_rows,size_array_cols,"grid:grid"); - memory->create(gridall,size_array_rows,size_array_cols,"grid:gridall"); - memory->create(grid_local,size_array_rows,"grid:grid_local"); - array = gridall; -} /* ---------------------------------------------------------------------- memory usage of local data ------------------------------------------------------------------------- */ @@ -207,6 +246,7 @@ double ComputeGrid::memory_usage() { double nbytes = size_array_rows*size_array_cols * sizeof(double); // grid - nbytes += size_array_rows*sizeof(int); // grid_local + nbytes += size_array_rows*sizeof(int); // local_flags + nbytes += size_array_cols*ngridlocal*sizeof(double); // gridlocal return nbytes; } diff --git a/src/compute_grid.h b/src/compute_grid.h index a1c938db2e..7e1a4d706b 100644 --- a/src/compute_grid.h +++ b/src/compute_grid.h @@ -30,11 +30,14 @@ class ComputeGrid : public Compute { double memory_usage(); protected: - int nx, ny, nz; // grid dimensions - int ngrid; // number of grid points + int nx, ny, nz; // global grid dimensions + int nxlo, nxhi, nylo, nyhi, nzlo, nzhi; // local grid bounds, inclusive + int ngrid; // number of global grid points + int ngridlocal; // number of local grid points int nvalues; // number of values per grid point double **grid; // global grid double **gridall; // global grid summed over procs + double ****gridlocal; // local grid int triclinic; // triclinic flag double *boxlo, *prd; // box info (units real/ortho or reduced/tri) double *sublo, *subhi; // subdomain info (units real/ortho or reduced/tri) @@ -43,12 +46,14 @@ class ComputeGrid : public Compute { int nargbase; // number of base class args double cutmax; // largest cutoff distance int size_array_cols_base; // number of columns used for coords, etc. - int *grid_local; // local flag for each grid point + int *local_flags; // local flag for each grid point void allocate(); void grid2x(int, double*); // convert grid point to coord - void assign_grid_coords(); // assign coords for grid - void assign_grid_local(); // set local flag for each grid point - int check_grid_local(int); // check if grid point is local + void assign_coords(); // assign coords for grid + void assign_local_flags(); // set local flag for each grid point + int check_local(int); // check if grid point is local + void set_grid_global(); // set global grid + void set_grid_local(); // set bounds for local grid private: }; From 4c22f094de1c0a5632c3514974f75bc6e2c85c78 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Fri, 2 Jul 2021 18:15:55 -0600 Subject: [PATCH 018/585] Minor tweak --- src/compute_grid.cpp | 2 -- 1 file changed, 2 deletions(-) diff --git a/src/compute_grid.cpp b/src/compute_grid.cpp index b16a51b739..1939dd544e 100644 --- a/src/compute_grid.cpp +++ b/src/compute_grid.cpp @@ -74,7 +74,6 @@ void ComputeGrid::init() void ComputeGrid::setup() { - set_grid_global(); set_grid_local(); allocate(); @@ -149,7 +148,6 @@ void ComputeGrid::assign_coords() void ComputeGrid::assign_local_flags() { - double x[3]; for (int igrid = 0; igrid < ngrid; igrid++) { if (check_local(igrid)) local_flags[igrid] = 1; From 07db7a40955ebb356ea16166985b1b296d1d8bb3 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Wed, 14 Jul 2021 13:35:05 -0600 Subject: [PATCH 019/585] Changed to different check_local() --- src/SNAP/compute_sna_grid.cpp | 6 +-- src/compute_grid.cpp | 75 ++++++++++++++++++++++++++--------- src/compute_grid.h | 3 ++ 3 files changed, 63 insertions(+), 21 deletions(-) diff --git a/src/SNAP/compute_sna_grid.cpp b/src/SNAP/compute_sna_grid.cpp index 196819008c..d2c2ae74ca 100644 --- a/src/SNAP/compute_sna_grid.cpp +++ b/src/SNAP/compute_sna_grid.cpp @@ -231,10 +231,10 @@ void ComputeSNAGrid::compute_array() gridlocal[size_array_cols_base+ncount++][iz][iy][ix] = 0.5*bi*bi; - // upper-triangular elements of quadratic matrix + // upper-triangular elements of quadratic matrix - for (int jcoeff = icoeff+1; jcoeff < ncoeff; jcoeff++) - gridlocal[size_array_cols_base+ncount++][iz][iy][ix] = bi*snaptr->blist[jcoeff]; + for (int jcoeff = icoeff+1; jcoeff < ncoeff; jcoeff++) + gridlocal[size_array_cols_base+ncount++][iz][iy][ix] = bi*snaptr->blist[jcoeff]; } } } diff --git a/src/compute_grid.cpp b/src/compute_grid.cpp index 1939dd544e..3cbcb2c2db 100644 --- a/src/compute_grid.cpp +++ b/src/compute_grid.cpp @@ -53,6 +53,7 @@ ComputeGrid::ComputeGrid(LAMMPS *lmp, int narg, char **arg) : size_array_rows = ngrid = nx*ny*nz; size_array_cols_base = 3; + gridlocal_allocated = 0; } /* ---------------------------------------------------------------------- */ @@ -61,7 +62,8 @@ ComputeGrid::~ComputeGrid() { memory->destroy(grid); memory->destroy(local_flags); - memory->destroy4d_offset(gridlocal,nzlo,nylo,nxlo); + if (gridlocal_allocated) + memory->destroy4d_offset(gridlocal,nzlo,nylo,nxlo); } /* ---------------------------------------------------------------------- */ @@ -101,28 +103,59 @@ void ComputeGrid::grid2x(int igrid, double *x) } +/* ---------------------------------------------------------------------- + convert global array index to box coords +------------------------------------------------------------------------- */ + +void ComputeGrid::grid2ix(int igrid, int& ix, int& iy, int& iz) +{ + iz = igrid / (nx*ny); + igrid -= iz * (nx*ny); + iy = igrid / nx; + igrid -= iy * nx; + ix = igrid; +} + +// /* ---------------------------------------------------------------------- +// check if grid point is local +// ------------------------------------------------------------------------- */ + +// int ComputeGrid::check_local(int igrid) +// { +// double x[3]; + +// int iz = igrid / (nx*ny); +// igrid -= iz * (nx*ny); +// int iy = igrid / nx; +// igrid -= iy * nx; +// int ix = igrid; + +// x[0] = ix*delx; +// x[1] = iy*dely; +// x[2] = iz*delz; + +// int islocal = +// x[0] >= sublo[0] && x[0] < subhi[0] && +// x[1] >= sublo[1] && x[1] < subhi[1] && +// x[2] >= sublo[2] && x[2] < subhi[2]; + +// return islocal; +// } + /* ---------------------------------------------------------------------- check if grid point is local ------------------------------------------------------------------------- */ int ComputeGrid::check_local(int igrid) { - double x[3]; + int ix, iy, iz; - int iz = igrid / (nx*ny); - igrid -= iz * (nx*ny); - int iy = igrid / nx; - igrid -= iy * nx; - int ix = igrid; - - x[0] = ix*delx; - x[1] = iy*dely; - x[2] = iz*delz; + grid2ix(igrid, ix, iy, iz); int islocal = - x[0] >= sublo[0] && x[0] < subhi[0] && - x[1] >= sublo[1] && x[1] < subhi[1] && - x[2] >= sublo[2] && x[2] < subhi[2]; + ix >= nxlo && ix <= nxhi && + iy >= nylo && iy <= nyhi && + iz >= nzlo && iz <= nzhi; return islocal; } @@ -153,7 +186,7 @@ void ComputeGrid::assign_local_flags() local_flags[igrid] = 1; else { local_flags[igrid] = 0; - memset(grid[igrid],0,size_array_cols); + memset(grid[igrid],0,size_array_cols * sizeof(double)); } } } @@ -168,12 +201,16 @@ void ComputeGrid::allocate() memory->destroy(grid); memory->destroy(local_flags); - memory->destroy4d_offset(gridlocal,nzlo,nylo,nxlo); + if (gridlocal_allocated) + memory->destroy4d_offset(gridlocal,nzlo,nylo,nxlo); memory->create(grid,size_array_rows,size_array_cols,"grid:grid"); memory->create(gridall,size_array_rows,size_array_cols,"grid:gridall"); memory->create(local_flags,size_array_rows,"grid:local_flags"); - memory->create4d_offset(gridlocal,size_array_cols,nzlo,nzhi,nylo,nyhi, - nxlo,nxhi,"grid:gridlocal"); + if (nxlo <= nxhi && nylo <= nyhi && nzlo <= nzhi) { + gridlocal_allocated = 1; + memory->create4d_offset(gridlocal,size_array_cols,nzlo,nzhi,nylo,nyhi, + nxlo,nxhi,"grid:gridlocal"); + } array = gridall; } @@ -234,6 +271,8 @@ void ComputeGrid::set_grid_local() nzhi = static_cast (comm->zsplit[comm->myloc[2]+1] * nz) - 1; ngridlocal = (nxhi - nxlo + 1) * (nyhi - nylo + 1) * (nzhi - nzlo + 1); + + printf("me = %d n = %d x %d %d y %d %d z %d %d \n", comm->me, ngridlocal, nxlo, nxhi, nylo, nyhi, nzlo, nzhi); } /* ---------------------------------------------------------------------- diff --git a/src/compute_grid.h b/src/compute_grid.h index 7e1a4d706b..1b2797732d 100644 --- a/src/compute_grid.h +++ b/src/compute_grid.h @@ -47,8 +47,11 @@ class ComputeGrid : public Compute { double cutmax; // largest cutoff distance int size_array_cols_base; // number of columns used for coords, etc. int *local_flags; // local flag for each grid point + int gridlocal_allocated; // shows if gridlocal allocated + void allocate(); void grid2x(int, double*); // convert grid point to coord + void grid2ix(int, int&, int&, int&); // convert grid point to ix, iy, iz void assign_coords(); // assign coords for grid void assign_local_flags(); // set local flag for each grid point int check_local(int); // check if grid point is local From 6378d1d128612d3ee6f214bebcb88df54604a7fc Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Wed, 14 Jul 2021 13:50:49 -0600 Subject: [PATCH 020/585] Moved SNAP files to ML-SNAP --- src/{SNAP => ML-SNAP}/compute_sna_grid.cpp | 0 src/{SNAP => ML-SNAP}/compute_sna_grid.h | 0 2 files changed, 0 insertions(+), 0 deletions(-) rename src/{SNAP => ML-SNAP}/compute_sna_grid.cpp (100%) rename src/{SNAP => ML-SNAP}/compute_sna_grid.h (100%) diff --git a/src/SNAP/compute_sna_grid.cpp b/src/ML-SNAP/compute_sna_grid.cpp similarity index 100% rename from src/SNAP/compute_sna_grid.cpp rename to src/ML-SNAP/compute_sna_grid.cpp diff --git a/src/SNAP/compute_sna_grid.h b/src/ML-SNAP/compute_sna_grid.h similarity index 100% rename from src/SNAP/compute_sna_grid.h rename to src/ML-SNAP/compute_sna_grid.h From 614c3bc5b9905ba6c306a74208636e9eb9cd76c1 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Mon, 19 Jul 2021 14:44:08 -0600 Subject: [PATCH 021/585] Merged in old compute-grid --- src/ML-SNAP/compute_sna_grid.cpp | 122 +++++++++++++++++++++++-------- src/ML-SNAP/compute_sna_grid.h | 6 +- src/ML-SNAP/compute_snap.cpp | 2 - src/compute_grid.cpp | 6 +- 4 files changed, 98 insertions(+), 38 deletions(-) diff --git a/src/ML-SNAP/compute_sna_grid.cpp b/src/ML-SNAP/compute_sna_grid.cpp index d2c2ae74ca..89e4b450bb 100644 --- a/src/ML-SNAP/compute_sna_grid.cpp +++ b/src/ML-SNAP/compute_sna_grid.cpp @@ -13,8 +13,6 @@ #include "compute_grid.h" #include "compute_sna_grid.h" -#include -#include #include "sna.h" #include "atom.h" #include "update.h" @@ -27,17 +25,20 @@ #include "comm.h" #include "memory.h" #include "error.h" +#include "tokenizer.h" + +#include +#include using namespace LAMMPS_NS; ComputeSNAGrid::ComputeSNAGrid(LAMMPS *lmp, int narg, char **arg) : - ComputeGrid(lmp, narg, arg), cutsq(NULL), sna(NULL), - radelem(NULL), wjelem(NULL) + ComputeGrid(lmp, narg, arg), cutsq(nullptr), + radelem(nullptr), wjelem(nullptr) { - double rmin0, rfac0; - int twojmax, switchflag, bzeroflag; - radelem = NULL; - wjelem = NULL; + + double rfac0, rmin0; + int twojmax, switchflag, bzeroflag, bnormflag, wselfallflag; // skip over arguments used by base class // so that argument positions are identical to @@ -57,10 +58,14 @@ ComputeSNAGrid::ComputeSNAGrid(LAMMPS *lmp, int narg, char **arg) : switchflag = 1; bzeroflag = 1; quadraticflag = 0; + chemflag = 0; + bnormflag = 0; + wselfallflag = 0; + nelements = 1; + + // process required arguments - // offset by 1 to match up with types - - memory->create(radelem,ntypes+1,"sna/grid:radelem"); + memory->create(radelem,ntypes+1,"sna/grid:radelem"); // offset by 1 to match up with types memory->create(wjelem,ntypes+1,"sna/grid:wjelem"); rcutfac = atof(arg[3]); @@ -112,12 +117,36 @@ ComputeSNAGrid::ComputeSNAGrid(LAMMPS *lmp, int narg, char **arg) : error->all(FLERR,"Illegal compute sna/grid command"); quadraticflag = atoi(arg[iarg+1]); iarg += 2; + } else if (strcmp(arg[iarg],"chem") == 0) { + if (iarg+2 > narg) + error->all(FLERR,"Illegal compute sna/grid command"); + chemflag = 1; + memory->create(map,ntypes+1,"compute_sna_grid:map"); + nelements = utils::inumeric(FLERR,arg[iarg+1],false,lmp); + for (int i = 0; i < ntypes; i++) { + int jelem = utils::inumeric(FLERR,arg[iarg+2+i],false,lmp); + if (jelem < 0 || jelem >= nelements) + error->all(FLERR,"Illegal compute sna/grid command"); + map[i+1] = jelem; + } + iarg += 2+ntypes; + } else if (strcmp(arg[iarg],"bnormflag") == 0) { + if (iarg+2 > narg) + error->all(FLERR,"Illegal compute sna/grid command"); + bnormflag = atoi(arg[iarg+1]); + iarg += 2; + } else if (strcmp(arg[iarg],"wselfallflag") == 0) { + if (iarg+2 > narg) + error->all(FLERR,"Illegal compute sna/grid command"); + wselfallflag = atoi(arg[iarg+1]); + iarg += 2; } else error->all(FLERR,"Illegal compute sna/grid command"); } - snaptr = new SNA(lmp,rfac0,twojmax, - rmin0,switchflag,bzeroflag); + snaptr = new SNA(lmp, rfac0, twojmax, + rmin0, switchflag, bzeroflag, + chemflag, bnormflag, wselfallflag, nelements); ncoeff = snaptr->ncoeff; nvalues = ncoeff; @@ -130,18 +159,19 @@ ComputeSNAGrid::ComputeSNAGrid(LAMMPS *lmp, int narg, char **arg) : ComputeSNAGrid::~ComputeSNAGrid() { - memory->destroy(sna); memory->destroy(radelem); memory->destroy(wjelem); memory->destroy(cutsq); delete snaptr; + + if (chemflag) memory->destroy(map); } /* ---------------------------------------------------------------------- */ void ComputeSNAGrid::init() { - if (force->pair == NULL) + if (force->pair == nullptr) error->all(FLERR,"Compute sna/grid requires a pair style be defined"); if (cutmax > force->pair->cutforce) @@ -170,12 +200,28 @@ void ComputeSNAGrid::compute_array() { invoked_array = update->ntimestep; - int * const type = atom->type; + // invoke full neighbor list (will copy or build if necessary) + + // neighbor->build_one(list); + + int mynxlo = static_cast (comm->xsplit[comm->myloc[0]] * nx); + int mynxhi = static_cast (comm->xsplit[comm->myloc[0]+1] * nx) - 1; + + int mynylo = static_cast (comm->ysplit[comm->myloc[1]] * ny); + int mynyhi = static_cast (comm->ysplit[comm->myloc[1]+1] * ny) - 1; + + int mynzlo = static_cast (comm->zsplit[comm->myloc[2]] * nz); + int mynzhi = static_cast (comm->zsplit[comm->myloc[2]+1] * nz) - 1; + + int myngridlocal = (nxhi - nxlo + 1) * (nyhi - nylo + 1) * (nzhi - nzlo + 1); + + printf("me = %d n = %d x %d %d y %d %d z %d %d \n", comm->me, myngridlocal, mynxlo, mynxhi, mynylo, mynyhi, mynzlo, mynzhi); // compute sna for each gridpoint double** const x = atom->x; const int* const mask = atom->mask; + int * const type = atom->type; const int ntotal = atom->nlocal + atom->nghost; // insure rij, inside, and typej are of size jnum @@ -190,6 +236,14 @@ void ComputeSNAGrid::compute_array() const double ytmp = grid[igrid][1]; const double ztmp = grid[igrid][2]; + // currently, all grid points are type 1 + + const int itype = 1; + int ielem = 0; + if (chemflag) + ielem = map[itype]; + const double radi = radelem[itype]; + // rij[][3] = displacements between atom I and those neighbors // inside = indices of neighbors of I within cutoff // typej = types of neighbors of I within cutoff @@ -206,6 +260,9 @@ void ComputeSNAGrid::compute_array() const double delz = ztmp - x[j][2]; const double rsq = delx*delx + dely*dely + delz*delz; int jtype = type[j]; + int jelem = 0; + if (chemflag) + jelem = map[jtype]; if (rsq < cutsq[jtype][jtype] && rsq>1e-20) { snaptr->rij[ninside][0] = delx; snaptr->rij[ninside][1] = dely; @@ -213,32 +270,33 @@ void ComputeSNAGrid::compute_array() snaptr->inside[ninside] = j; snaptr->wj[ninside] = wjelem[jtype]; snaptr->rcutij[ninside] = 2.0*radelem[jtype]*rcutfac; + snaptr->element[ninside] = jelem; // element index for multi-element snap ninside++; } } - snaptr->compute_ui(ninside); + snaptr->compute_ui(ninside, ielem); snaptr->compute_zi(); - snaptr->compute_bi(); + snaptr->compute_bi(ielem); + + // linear contributions + for (int icoeff = 0; icoeff < ncoeff; icoeff++) gridlocal[size_array_cols_base+icoeff][iz][iy][ix] = snaptr->blist[icoeff]; + + // quadratic contributions + if (quadraticflag) { int ncount = ncoeff; for (int icoeff = 0; icoeff < ncoeff; icoeff++) { - double bi = snaptr->blist[icoeff]; - - // diagonal element of quadratic matrix - - gridlocal[size_array_cols_base+ncount++][iz][iy][ix] = 0.5*bi*bi; - - // upper-triangular elements of quadratic matrix - + double bveci = snaptr->blist[icoeff]; + gridlocal[size_array_cols_base+ncount++][iz][iy][ix] = 0.5*bveci*bveci; for (int jcoeff = icoeff+1; jcoeff < ncoeff; jcoeff++) - gridlocal[size_array_cols_base+ncount++][iz][iy][ix] = bi*snaptr->blist[jcoeff]; + gridlocal[size_array_cols_base+ncount++][iz][iy][ix] = bveci*snaptr->blist[jcoeff]; + } + } } - } - } - + for (int iz = nzlo; iz <= nzhi; iz++) for (int iy = nylo; iy <= nyhi; iy++) for (int ix = nxlo; ix <= nxhi; ix++) { @@ -257,7 +315,9 @@ void ComputeSNAGrid::compute_array() double ComputeSNAGrid::memory_usage() { - double nbytes = snaptr->memory_usage(); // SNA object + double nbytes = snaptr->memory_usage(); // SNA object + int n = atom->ntypes+1; + nbytes += (double)n*sizeof(int); // map return nbytes; } diff --git a/src/ML-SNAP/compute_sna_grid.h b/src/ML-SNAP/compute_sna_grid.h index 0242a2962b..e2640081af 100644 --- a/src/ML-SNAP/compute_sna_grid.h +++ b/src/ML-SNAP/compute_sna_grid.h @@ -35,11 +35,13 @@ class ComputeSNAGrid : public ComputeGrid { private: int ncoeff; double **cutsq; - double **sna; double rcutfac; double *radelem; double *wjelem; - class SNA* snaptr; + int *map; // map types to [0,nelements) + int nelements, chemflag; + class SNA *snaptr; + double cutmax; int quadraticflag; }; diff --git a/src/ML-SNAP/compute_snap.cpp b/src/ML-SNAP/compute_snap.cpp index 63deff9f8f..6da7b78444 100644 --- a/src/ML-SNAP/compute_snap.cpp +++ b/src/ML-SNAP/compute_snap.cpp @@ -43,8 +43,6 @@ ComputeSnap::ComputeSnap(LAMMPS *lmp, int narg, char **arg) : double rfac0, rmin0; int twojmax, switchflag, bzeroflag, bnormflag, wselfallflag; - radelem = nullptr; - wjelem = nullptr; int ntypes = atom->ntypes; int nargmin = 6+2*ntypes; diff --git a/src/compute_grid.cpp b/src/compute_grid.cpp index 3cbcb2c2db..3bdbddbc0c 100644 --- a/src/compute_grid.cpp +++ b/src/compute_grid.cpp @@ -41,9 +41,9 @@ ComputeGrid::ComputeGrid(LAMMPS *lmp, int narg, char **arg) : int iarg = iarg0; if (strcmp(arg[iarg],"grid") == 0) { if (iarg+4 > narg) error->all(FLERR,"Illegal compute grid command"); - nx = force->inumeric(FLERR,arg[iarg+1]); - ny = force->inumeric(FLERR,arg[iarg+2]); - nz = force->inumeric(FLERR,arg[iarg+3]); + nx = utils::inumeric(FLERR,arg[iarg+1],false,lmp); + ny = utils::inumeric(FLERR,arg[iarg+2],false,lmp); + nz = utils::inumeric(FLERR,arg[iarg+3],false,lmp); if (nx <= 0 || ny <= 0 || nz <= 0) error->all(FLERR,"All grid dimensions must be positive"); iarg += 4; From 6d75912f7a567925c5f36ef19fd3f5e6d46d12ff Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Wed, 28 Jul 2021 18:34:08 -0600 Subject: [PATCH 022/585] Switched to local array --- src/ML-SNAP/compute_sna_grid.cpp | 30 +++++++++------ src/ML-SNAP/compute_sna_grid.h | 2 + src/compute_grid.cpp | 64 +++++++++++++++++++++++++------- 3 files changed, 71 insertions(+), 25 deletions(-) diff --git a/src/ML-SNAP/compute_sna_grid.cpp b/src/ML-SNAP/compute_sna_grid.cpp index 89e4b450bb..0b0c0674e4 100644 --- a/src/ML-SNAP/compute_sna_grid.cpp +++ b/src/ML-SNAP/compute_sna_grid.cpp @@ -22,6 +22,7 @@ #include "neigh_request.h" #include "force.h" #include "pair.h" +#include "domain.h" #include "comm.h" #include "memory.h" #include "error.h" @@ -196,26 +197,31 @@ void ComputeSNAGrid::init() /* ---------------------------------------------------------------------- */ +void ComputeSNAGrid::init_list(int /*id*/, NeighList *ptr) +{ + list = ptr; +} + +/* ---------------------------------------------------------------------- */ + void ComputeSNAGrid::compute_array() { invoked_array = update->ntimestep; - // invoke full neighbor list (will copy or build if necessary) + // // invoke full neighbor list (will copy or build if necessary) - // neighbor->build_one(list); + // neighbor->build_one(list); - int mynxlo = static_cast (comm->xsplit[comm->myloc[0]] * nx); - int mynxhi = static_cast (comm->xsplit[comm->myloc[0]+1] * nx) - 1; + // int mynxlo = static_cast (comm->xsplit[comm->myloc[0]] * nx); + // int mynxhi = static_cast (comm->xsplit[comm->myloc[0]+1] * nx) - 1; - int mynylo = static_cast (comm->ysplit[comm->myloc[1]] * ny); - int mynyhi = static_cast (comm->ysplit[comm->myloc[1]+1] * ny) - 1; + // int mynylo = static_cast (comm->ysplit[comm->myloc[1]] * ny); + // int mynyhi = static_cast (comm->ysplit[comm->myloc[1]+1] * ny) - 1; - int mynzlo = static_cast (comm->zsplit[comm->myloc[2]] * nz); - int mynzhi = static_cast (comm->zsplit[comm->myloc[2]+1] * nz) - 1; + // int mynzlo = static_cast (comm->zsplit[comm->myloc[2]] * nz); + // int mynzhi = static_cast (comm->zsplit[comm->myloc[2]+1] * nz) - 1; - int myngridlocal = (nxhi - nxlo + 1) * (nyhi - nylo + 1) * (nzhi - nzlo + 1); - - printf("me = %d n = %d x %d %d y %d %d z %d %d \n", comm->me, myngridlocal, mynxlo, mynxhi, mynylo, mynyhi, mynzlo, mynzhi); + // int myngridlocal = (nxhi - nxlo + 1) * (nyhi - nylo + 1) * (nzhi - nzlo + 1); // compute sna for each gridpoint @@ -263,7 +269,7 @@ void ComputeSNAGrid::compute_array() int jelem = 0; if (chemflag) jelem = map[jtype]; - if (rsq < cutsq[jtype][jtype] && rsq>1e-20) { + if (rsq < cutsq[jtype][jtype]) { snaptr->rij[ninside][0] = delx; snaptr->rij[ninside][1] = dely; snaptr->rij[ninside][2] = delz; diff --git a/src/ML-SNAP/compute_sna_grid.h b/src/ML-SNAP/compute_sna_grid.h index e2640081af..d40c87df9b 100644 --- a/src/ML-SNAP/compute_sna_grid.h +++ b/src/ML-SNAP/compute_sna_grid.h @@ -29,12 +29,14 @@ class ComputeSNAGrid : public ComputeGrid { ComputeSNAGrid(class LAMMPS *, int, char **); ~ComputeSNAGrid(); void init(); + void init_list(int, class NeighList *); void compute_array(); double memory_usage(); private: int ncoeff; double **cutsq; + class NeighList *list; double rcutfac; double *radelem; double *wjelem; diff --git a/src/compute_grid.cpp b/src/compute_grid.cpp index 3bdbddbc0c..740131deda 100644 --- a/src/compute_grid.cpp +++ b/src/compute_grid.cpp @@ -28,7 +28,7 @@ using namespace LAMMPS_NS; /* ---------------------------------------------------------------------- */ ComputeGrid::ComputeGrid(LAMMPS *lmp, int narg, char **arg) : - Compute(lmp, narg, arg), grid(NULL), local_flags(NULL), gridlocal(NULL) + Compute(lmp, narg, arg), grid(nullptr), gridall(nullptr), local_flags(nullptr), gridlocal(nullptr) { if (narg < 6) error->all(FLERR,"Illegal compute grid command"); @@ -61,9 +61,12 @@ ComputeGrid::ComputeGrid(LAMMPS *lmp, int narg, char **arg) : ComputeGrid::~ComputeGrid() { memory->destroy(grid); + memory->destroy(gridall); memory->destroy(local_flags); - if (gridlocal_allocated) + if (gridlocal_allocated) { + gridlocal_allocated = 0; memory->destroy4d_offset(gridlocal,nzlo,nylo,nxlo); + } } /* ---------------------------------------------------------------------- */ @@ -200,9 +203,14 @@ void ComputeGrid::allocate() // allocate arrays memory->destroy(grid); + memory->destroy(gridall); memory->destroy(local_flags); - if (gridlocal_allocated) - memory->destroy4d_offset(gridlocal,nzlo,nylo,nxlo); + if (gridlocal_allocated) { + gridlocal_allocated = 0; + // can't seem to do this without seg-fault + // memory->destroy4d_offset(gridlocal,nzlo,nylo,nxlo); + } + memory->create(grid,size_array_rows,size_array_cols,"grid:grid"); memory->create(gridall,size_array_rows,size_array_cols,"grid:gridall"); memory->create(local_flags,size_array_rows,"grid:local_flags"); @@ -257,18 +265,48 @@ void ComputeGrid::set_grid_global() void ComputeGrid::set_grid_local() { - // global indices of grid range from 0 to N-1 - // nlo,nhi = lower/upper limits of the 3d sub-brick of - // global grid that I own without ghost cells + // nx,ny,nz = extent of global grid + // indices into the global grid range from 0 to N-1 in each dim + // if grid point is inside my sub-domain I own it, + // this includes sub-domain lo boundary but excludes hi boundary + // ixyz lo/hi = inclusive lo/hi bounds of global grid sub-brick I own + // if proc owns no grid cells in a dim, then ilo > ihi + // if 2 procs share a boundary a grid point is exactly on, + // the 2 equality if tests insure a consistent decision + // as to which proc owns it - nxlo = static_cast (comm->xsplit[comm->myloc[0]] * nx); - nxhi = static_cast (comm->xsplit[comm->myloc[0]+1] * nx) - 1; + double xfraclo,xfrachi,yfraclo,yfrachi,zfraclo,zfrachi; - nylo = static_cast (comm->ysplit[comm->myloc[1]] * ny); - nyhi = static_cast (comm->ysplit[comm->myloc[1]+1] * ny) - 1; + if (comm->layout != Comm::LAYOUT_TILED) { + xfraclo = comm->xsplit[comm->myloc[0]]; + xfrachi = comm->xsplit[comm->myloc[0]+1]; + yfraclo = comm->ysplit[comm->myloc[1]]; + yfrachi = comm->ysplit[comm->myloc[1]+1]; + zfraclo = comm->zsplit[comm->myloc[2]]; + zfrachi = comm->zsplit[comm->myloc[2]+1]; + } else { + xfraclo = comm->mysplit[0][0]; + xfrachi = comm->mysplit[0][1]; + yfraclo = comm->mysplit[1][0]; + yfrachi = comm->mysplit[1][1]; + zfraclo = comm->mysplit[2][0]; + zfrachi = comm->mysplit[2][1]; + } - nzlo = static_cast (comm->zsplit[comm->myloc[2]] * nz); - nzhi = static_cast (comm->zsplit[comm->myloc[2]+1] * nz) - 1; + nxlo = static_cast (xfraclo * nx); + if (1.0*nxlo != xfraclo*nx) nxlo++; + nxhi = static_cast (xfrachi * nx); + if (1.0*nxhi == xfrachi*nx) nxhi--; + + nylo = static_cast (yfraclo * ny); + if (1.0*nylo != yfraclo*ny) nylo++; + nyhi = static_cast (yfrachi * ny); + if (1.0*nyhi == yfrachi*ny) nyhi--; + + nzlo = static_cast (zfraclo * nz); + if (1.0*nzlo != zfraclo*nz) nzlo++; + nzhi = static_cast (zfrachi * nz); + if (1.0*nzhi == zfrachi*nz) nzhi--; ngridlocal = (nxhi - nxlo + 1) * (nyhi - nylo + 1) * (nzhi - nzlo + 1); From 162868f13c5aa8b314634b0a89bbc8851a6f508c Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Fri, 30 Jul 2021 10:01:20 -0600 Subject: [PATCH 023/585] Readded r=0 check --- src/ML-SNAP/compute_sna_grid.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/ML-SNAP/compute_sna_grid.cpp b/src/ML-SNAP/compute_sna_grid.cpp index 0b0c0674e4..62778a9e83 100644 --- a/src/ML-SNAP/compute_sna_grid.cpp +++ b/src/ML-SNAP/compute_sna_grid.cpp @@ -269,7 +269,7 @@ void ComputeSNAGrid::compute_array() int jelem = 0; if (chemflag) jelem = map[jtype]; - if (rsq < cutsq[jtype][jtype]) { + if (rsq < cutsq[jtype][jtype] && rsq > 1e-20) { snaptr->rij[ninside][0] = delx; snaptr->rij[ninside][1] = dely; snaptr->rij[ninside][2] = delz; From 347e5a59783a4924aee2cf48a3b09c46c15d3374 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Sun, 22 Aug 2021 16:03:50 -0600 Subject: [PATCH 024/585] Created local grid that is used to populate global grid --- src/ML-SNAP/compute_sna_grid.cpp | 27 ++++++--------------------- src/compute_grid.cpp | 6 ++++-- 2 files changed, 10 insertions(+), 23 deletions(-) diff --git a/src/ML-SNAP/compute_sna_grid.cpp b/src/ML-SNAP/compute_sna_grid.cpp index 62778a9e83..2def0cf6a4 100644 --- a/src/ML-SNAP/compute_sna_grid.cpp +++ b/src/ML-SNAP/compute_sna_grid.cpp @@ -37,7 +37,6 @@ ComputeSNAGrid::ComputeSNAGrid(LAMMPS *lmp, int narg, char **arg) : ComputeGrid(lmp, narg, arg), cutsq(nullptr), radelem(nullptr), wjelem(nullptr) { - double rfac0, rmin0; int twojmax, switchflag, bzeroflag, bnormflag, wselfallflag; @@ -208,21 +207,6 @@ void ComputeSNAGrid::compute_array() { invoked_array = update->ntimestep; - // // invoke full neighbor list (will copy or build if necessary) - - // neighbor->build_one(list); - - // int mynxlo = static_cast (comm->xsplit[comm->myloc[0]] * nx); - // int mynxhi = static_cast (comm->xsplit[comm->myloc[0]+1] * nx) - 1; - - // int mynylo = static_cast (comm->ysplit[comm->myloc[1]] * ny); - // int mynyhi = static_cast (comm->ysplit[comm->myloc[1]+1] * ny) - 1; - - // int mynzlo = static_cast (comm->zsplit[comm->myloc[2]] * nz); - // int mynzhi = static_cast (comm->zsplit[comm->myloc[2]+1] * nz) - 1; - - // int myngridlocal = (nxhi - nxlo + 1) * (nyhi - nylo + 1) * (nzhi - nzlo + 1); - // compute sna for each gridpoint double** const x = atom->x; @@ -285,7 +269,7 @@ void ComputeSNAGrid::compute_array() snaptr->compute_zi(); snaptr->compute_bi(ielem); - // linear contributions + // linear contributions for (int icoeff = 0; icoeff < ncoeff; icoeff++) gridlocal[size_array_cols_base+icoeff][iz][iy][ix] = snaptr->blist[icoeff]; @@ -302,16 +286,17 @@ void ComputeSNAGrid::compute_array() } } } - + for (int iz = nzlo; iz <= nzhi; iz++) for (int iy = nylo; iy <= nyhi; iy++) for (int ix = nxlo; ix <= nxhi; ix++) { - const int igrid = iz*(nx*ny) + iy*nx + ix; - for (int j = 0; j < nvalues; j++) - grid[igrid][size_array_cols_base + j] = gridlocal[size_array_cols_base + j][iz][iy][ix]; + const int igrid = iz*(nx*ny) + iy*nx + ix; + for (int j = 0; j < nvalues; j++) + grid[igrid][size_array_cols_base + j] = gridlocal[size_array_cols_base + j][iz][iy][ix]; } MPI_Allreduce(&grid[0][0],&gridall[0][0],ngrid*size_array_cols,MPI_DOUBLE,MPI_SUM,world); + } diff --git a/src/compute_grid.cpp b/src/compute_grid.cpp index 740131deda..0d880b94d5 100644 --- a/src/compute_grid.cpp +++ b/src/compute_grid.cpp @@ -207,8 +207,11 @@ void ComputeGrid::allocate() memory->destroy(local_flags); if (gridlocal_allocated) { gridlocal_allocated = 0; - // can't seem to do this without seg-fault + // MEMORY LEAK!! + // can't seem to free this memory without seg-fault + // printf("Before allocate destroy4d, proc %d %p\n",comm->me,gridlocal); // memory->destroy4d_offset(gridlocal,nzlo,nylo,nxlo); + // printf("After allocate destroy4d, proc %d %p\n",comm->me,gridlocal); } memory->create(grid,size_array_rows,size_array_cols,"grid:grid"); @@ -310,7 +313,6 @@ void ComputeGrid::set_grid_local() ngridlocal = (nxhi - nxlo + 1) * (nyhi - nylo + 1) * (nzhi - nzlo + 1); - printf("me = %d n = %d x %d %d y %d %d z %d %d \n", comm->me, ngridlocal, nxlo, nxhi, nylo, nyhi, nzlo, nzhi); } /* ---------------------------------------------------------------------- From 94c97e83a2b108f681a90ea72a0d4e340ba269bc Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Sun, 22 Aug 2021 18:30:02 -0600 Subject: [PATCH 025/585] Added this helper file --- examples/snap/lammps_utils.py | 26 ++++++++++++++++++++++++++ 1 file changed, 26 insertions(+) create mode 100644 examples/snap/lammps_utils.py diff --git a/examples/snap/lammps_utils.py b/examples/snap/lammps_utils.py new file mode 100644 index 0000000000..ea74459a74 --- /dev/null +++ b/examples/snap/lammps_utils.py @@ -0,0 +1,26 @@ +import numpy as np +import ctypes + +def set_cmdlinevars(cmdargs, argdict): + for key in argdict.keys(): + cmdargs += ["-var",key,f"{argdict[key]}"] + return cmdargs + +def extract_commands(string): + return [x for x in string.splitlines() if x.strip() != ''] + +def extract_compute_np(lmp,name,compute_type,result_type,array_shape): + """ + Convert a lammps compute to a numpy array. + Assumes the compute returns a floating point numbers. + Note that the result is a view into the original memory. + If the result type is 0 (scalar) then conversion to numpy is skipped and a python float is returned. + """ + ptr = lmp.extract_compute(name, compute_type, result_type) # 1,2: Style (1) is per-atom compute, returns array type (2). + if result_type == 0: return ptr # No casting needed, lammps.py already works + if result_type == 2: ptr = ptr.contents + total_size = np.prod(array_shape) + buffer_ptr = ctypes.cast(ptr, ctypes.POINTER(ctypes.c_double * total_size)) + array_np = np.frombuffer(buffer_ptr.contents, dtype=float) + array_np.shape = array_shape + return array_np From 1b1f6f29c251b8c03d254737927149ebdba08211 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Sun, 22 Aug 2021 18:44:35 -0600 Subject: [PATCH 026/585] Updated grid.py to use sna/grid/local compute, but it seg-faults --- examples/snap/in.grid.python | 4 ++++ 1 file changed, 4 insertions(+) diff --git a/examples/snap/in.grid.python b/examples/snap/in.grid.python index 13fe6d0638..e04415d558 100644 --- a/examples/snap/in.grid.python +++ b/examples/snap/in.grid.python @@ -43,6 +43,8 @@ compute b all sna/atom ${rcutfac} ${rfac0} ${twojmax} ${radelem} ${wj} rmin0 ${r compute bgrid all sna/grid grid ${ngridx} ${ngridy} ${ngridz} ${rcutfac} ${rfac0} ${twojmax} ${radelem} ${wj} rmin0 ${rmin0} bzeroflag ${bzero} quadraticflag ${quad} switchflag ${switch} +compute bgridlocal all sna/grid/local grid ${ngridx} ${ngridy} ${ngridz} ${rcutfac} ${rfac0} ${twojmax} ${radelem} ${wj} rmin0 ${rmin0} bzeroflag ${bzero} quadraticflag ${quad} switchflag ${switch} + # create dummy potential for neighbor list variable rcutneigh equal 2.0*${rcutfac}*${radelem} @@ -56,6 +58,8 @@ thermo_modify norm yes dump mydump_b all custom 1000 dump_b id c_b[*] +dump mydump_bgridlocal all local 1000 dump_bgridlocal index c_bgridlocal[1] + # run run 0 From f473ca498bbe32b6439bfe78cfc937ef5e54fe71 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Sun, 22 Aug 2021 19:24:23 -0600 Subject: [PATCH 027/585] Created in.grid.local, fixed some problems in src --- examples/snap/in.grid.local | 73 ++++++ src/ML-SNAP/compute_sna_grid_local.cpp | 308 +++++++++++++++++++++++++ src/ML-SNAP/compute_sna_grid_local.h | 75 ++++++ src/compute_grid_local.cpp | 253 ++++++++++++++++++++ src/compute_grid_local.h | 69 ++++++ 5 files changed, 778 insertions(+) create mode 100644 examples/snap/in.grid.local create mode 100644 src/ML-SNAP/compute_sna_grid_local.cpp create mode 100644 src/ML-SNAP/compute_sna_grid_local.h create mode 100644 src/compute_grid_local.cpp create mode 100644 src/compute_grid_local.h diff --git a/examples/snap/in.grid.local b/examples/snap/in.grid.local new file mode 100644 index 0000000000..dc04fd5371 --- /dev/null +++ b/examples/snap/in.grid.local @@ -0,0 +1,73 @@ +# Demonstrate bispectrum computes with local grid + +# Initialize simulation + +variable nsteps index 0 +variable nrep index 1 +variable a index 3.316 +variable ngrid index 2 + +units metal + +# generate the box and atom positions using a BCC lattice + +variable nx equal ${nrep} +variable ny equal ${nrep} +variable nz equal ${nrep} + +boundary p p p + +lattice custom $a & + a1 1 0 0 & + a2 0 1 0 & + a3 0 0 1 & + basis 0 0 0 & + basis 0.5 0.5 0.5 & +# origin 0.25 0.25 0.25 + +region box block 0 ${nx} 0 ${ny} 0 ${nz} +create_box 1 box +create_atoms 1 box + +mass 1 180.88 + +# choose potential + +include Ta06A.snap + +# define grid compute and atom compute + +group snapgroup type 1 +variable twojmax equal 2 +variable rcutfac equal 4.67637 +variable rfac0 equal 0.99363 +variable rmin0 equal 0 +variable wj equal 1 +variable radelem equal 0.5 +variable bzero equal 0 +variable quad equal 0 +variable switch equal 1 + +compute b all sna/atom & + ${rcutfac} ${rfac0} ${twojmax} ${radelem} & + ${wj} rmin0 ${rmin0} bzeroflag ${bzero} & + quadraticflag ${quad} switchflag ${switch} + +compute mygridlocal all sna/grid/local grid ${ngrid} ${ngrid} ${ngrid} & + ${rcutfac} ${rfac0} ${twojmax} ${radelem} & + ${wj} rmin0 ${rmin0} bzeroflag ${bzero} & + quadraticflag ${quad} switchflag ${switch} + +# define output + +# mygrid is ngrid by (3+nbis) = 8x8 +thermo_style custom step temp ke pe vol +thermo_modify norm yes + +dump mydump_b all custom 1000 dump_b id c_b[*] +dump mydump_bgridlocal all local 1000 dump_bgridlocal index c_mygridlocal[*] + +# run + +run 0 + diff --git a/src/ML-SNAP/compute_sna_grid_local.cpp b/src/ML-SNAP/compute_sna_grid_local.cpp new file mode 100644 index 0000000000..18d9f5496d --- /dev/null +++ b/src/ML-SNAP/compute_sna_grid_local.cpp @@ -0,0 +1,308 @@ +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#include "compute_grid_local.h" +#include "compute_sna_grid_local.h" +#include "sna.h" +#include "atom.h" +#include "update.h" +#include "modify.h" +#include "neighbor.h" +#include "neigh_list.h" +#include "neigh_request.h" +#include "force.h" +#include "pair.h" +#include "domain.h" +#include "comm.h" +#include "memory.h" +#include "error.h" +#include "tokenizer.h" + +#include +#include + +using namespace LAMMPS_NS; + +ComputeSNAGridLocal::ComputeSNAGridLocal(LAMMPS *lmp, int narg, char **arg) : + ComputeGridLocal(lmp, narg, arg), cutsq(nullptr), + radelem(nullptr), wjelem(nullptr) +{ + double rfac0, rmin0; + int twojmax, switchflag, bzeroflag, bnormflag, wselfallflag; + + // skip over arguments used by base class + // so that argument positions are identical to + // regular per-atom compute + + arg += nargbase; + narg -= nargbase; + + int ntypes = atom->ntypes; + int nargmin = 6+2*ntypes; + + if (narg < nargmin) error->all(FLERR,"Illegal compute sna/grid/local command"); + + // default values + + rmin0 = 0.0; + switchflag = 1; + bzeroflag = 1; + quadraticflag = 0; + chemflag = 0; + bnormflag = 0; + wselfallflag = 0; + nelements = 1; + + // process required arguments + + memory->create(radelem,ntypes+1,"sna/grid/local:radelem"); // offset by 1 to match up with types + memory->create(wjelem,ntypes+1,"sna/grid/local:wjelem"); + + rcutfac = atof(arg[3]); + rfac0 = atof(arg[4]); + twojmax = atoi(arg[5]); + + for(int i = 0; i < ntypes; i++) + radelem[i+1] = atof(arg[6+i]); + for(int i = 0; i < ntypes; i++) + wjelem[i+1] = atof(arg[6+ntypes+i]); + + // construct cutsq + + double cut; + cutmax = 0.0; + memory->create(cutsq,ntypes+1,ntypes+1,"sna/grid/local:cutsq"); + for(int i = 1; i <= ntypes; i++) { + cut = 2.0*radelem[i]*rcutfac; + if (cut > cutmax) cutmax = cut; + cutsq[i][i] = cut*cut; + for(int j = i+1; j <= ntypes; j++) { + cut = (radelem[i]+radelem[j])*rcutfac; + cutsq[i][j] = cutsq[j][i] = cut*cut; + } + } + + // process optional args + + int iarg = nargmin; + + while (iarg < narg) { + if (strcmp(arg[iarg],"rmin0") == 0) { + if (iarg+2 > narg) + error->all(FLERR,"Illegal compute sna/grid/local command"); + rmin0 = atof(arg[iarg+1]); + iarg += 2; + } else if (strcmp(arg[iarg],"switchflag") == 0) { + if (iarg+2 > narg) + error->all(FLERR,"Illegal compute sna/grid/local command"); + switchflag = atoi(arg[iarg+1]); + iarg += 2; + } else if (strcmp(arg[iarg],"bzeroflag") == 0) { + if (iarg+2 > narg) + error->all(FLERR,"Illegal compute sna/grid/local command"); + bzeroflag = atoi(arg[iarg+1]); + iarg += 2; + } else if (strcmp(arg[iarg],"quadraticflag") == 0) { + if (iarg+2 > narg) + error->all(FLERR,"Illegal compute sna/grid/local command"); + quadraticflag = atoi(arg[iarg+1]); + iarg += 2; + } else if (strcmp(arg[iarg],"chem") == 0) { + if (iarg+2 > narg) + error->all(FLERR,"Illegal compute sna/grid/local command"); + chemflag = 1; + memory->create(map,ntypes+1,"compute_sna_grid_local:map"); + nelements = utils::inumeric(FLERR,arg[iarg+1],false,lmp); + for (int i = 0; i < ntypes; i++) { + int jelem = utils::inumeric(FLERR,arg[iarg+2+i],false,lmp); + if (jelem < 0 || jelem >= nelements) + error->all(FLERR,"Illegal compute sna/grid/local command"); + map[i+1] = jelem; + } + iarg += 2+ntypes; + } else if (strcmp(arg[iarg],"bnormflag") == 0) { + if (iarg+2 > narg) + error->all(FLERR,"Illegal compute sna/grid/local command"); + bnormflag = atoi(arg[iarg+1]); + iarg += 2; + } else if (strcmp(arg[iarg],"wselfallflag") == 0) { + if (iarg+2 > narg) + error->all(FLERR,"Illegal compute sna/grid/local command"); + wselfallflag = atoi(arg[iarg+1]); + iarg += 2; + } else error->all(FLERR,"Illegal compute sna/grid/local command"); + + } + + snaptr = new SNA(lmp, rfac0, twojmax, + rmin0, switchflag, bzeroflag, + chemflag, bnormflag, wselfallflag, nelements); + + ncoeff = snaptr->ncoeff; + nvalues = ncoeff; + if (quadraticflag) nvalues += (ncoeff*(ncoeff+1))/2; + size_local_cols = size_local_cols_base + nvalues; +} + +/* ---------------------------------------------------------------------- */ + +ComputeSNAGridLocal::~ComputeSNAGridLocal() +{ + memory->destroy(radelem); + memory->destroy(wjelem); + memory->destroy(cutsq); + delete snaptr; + + if (chemflag) memory->destroy(map); +} + +/* ---------------------------------------------------------------------- */ + +void ComputeSNAGridLocal::init() +{ + if (force->pair == nullptr) + error->all(FLERR,"Compute sna/grid/local requires a pair style be defined"); + + if (cutmax > force->pair->cutforce) + error->all(FLERR,"Compute sna/grid/local cutoff is longer than pairwise cutoff"); + + // need an occasional full neighbor list + + int irequest = neighbor->request(this,instance_me); + neighbor->requests[irequest]->pair = 0; + neighbor->requests[irequest]->compute = 1; + neighbor->requests[irequest]->half = 0; + neighbor->requests[irequest]->full = 1; + neighbor->requests[irequest]->occasional = 1; + + int count = 0; + for (int i = 0; i < modify->ncompute; i++) + if (strcmp(modify->compute[i]->style,"sna/grid/local") == 0) count++; + if (count > 1 && comm->me == 0) + error->warning(FLERR,"More than one compute sna/grid/local"); + snaptr->init(); +} + +/* ---------------------------------------------------------------------- */ + +void ComputeSNAGridLocal::init_list(int /*id*/, NeighList *ptr) +{ + list = ptr; +} + +/* ---------------------------------------------------------------------- */ + +void ComputeSNAGridLocal::compute_local() +{ + invoked_array = update->ntimestep; + + // compute sna for each gridpoint + + double** const x = atom->x; + const int* const mask = atom->mask; + int * const type = atom->type; + const int ntotal = atom->nlocal + atom->nghost; + + // insure rij, inside, and typej are of size jnum + + snaptr->grow_rij(ntotal); + + for (int iz = nzlo; iz <= nzhi; iz++) + for (int iy = nylo; iy <= nyhi; iy++) + for (int ix = nxlo; ix <= nxhi; ix++) { + double xgrid[3]; + grid2x(ix, iy, iz, xgrid); + const double xtmp = xgrid[0]; + const double ytmp = xgrid[1]; + const double ztmp = xgrid[2]; + + // currently, all grid points are type 1 + + const int itype = 1; + int ielem = 0; + if (chemflag) + ielem = map[itype]; + const double radi = radelem[itype]; + + // rij[][3] = displacements between atom I and those neighbors + // inside = indices of neighbors of I within cutoff + // typej = types of neighbors of I within cutoff + + int ninside = 0; + for (int j = 0; j < ntotal; j++) { + + // check that j is in compute group + + if (!(mask[j] & groupbit)) continue; + + const double delx = xtmp - x[j][0]; + const double dely = ytmp - x[j][1]; + const double delz = ztmp - x[j][2]; + const double rsq = delx*delx + dely*dely + delz*delz; + int jtype = type[j]; + int jelem = 0; + if (chemflag) + jelem = map[jtype]; + if (rsq < cutsq[jtype][jtype] && rsq > 1e-20) { + snaptr->rij[ninside][0] = delx; + snaptr->rij[ninside][1] = dely; + snaptr->rij[ninside][2] = delz; + snaptr->inside[ninside] = j; + snaptr->wj[ninside] = wjelem[jtype]; + snaptr->rcutij[ninside] = 2.0*radelem[jtype]*rcutfac; + snaptr->element[ninside] = jelem; // element index for multi-element snap + ninside++; + } + } + + snaptr->compute_ui(ninside, ielem); + snaptr->compute_zi(); + snaptr->compute_bi(ielem); + + // linear contributions + + for (int icoeff = 0; icoeff < ncoeff; icoeff++) + gridlocal[size_local_cols_base+icoeff][iz][iy][ix] = snaptr->blist[icoeff]; + + // quadratic contributions + + if (quadraticflag) { + int ncount = ncoeff; + for (int icoeff = 0; icoeff < ncoeff; icoeff++) { + double bveci = snaptr->blist[icoeff]; + gridlocal[size_local_cols_base+ncount++][iz][iy][ix] = 0.5*bveci*bveci; + for (int jcoeff = icoeff+1; jcoeff < ncoeff; jcoeff++) + gridlocal[size_local_cols_base+ncount++][iz][iy][ix] = bveci*snaptr->blist[jcoeff]; + } + } + } + + // copy 4d array to 2d array + + copy_gridlocal_to_local_array(); +} + + +/* ---------------------------------------------------------------------- + memory usage +------------------------------------------------------------------------- */ + +double ComputeSNAGridLocal::memory_usage() +{ + double nbytes = snaptr->memory_usage(); // SNA object + int n = atom->ntypes+1; + nbytes += (double)n*sizeof(int); // map + + return nbytes; +} + diff --git a/src/ML-SNAP/compute_sna_grid_local.h b/src/ML-SNAP/compute_sna_grid_local.h new file mode 100644 index 0000000000..21e321d123 --- /dev/null +++ b/src/ML-SNAP/compute_sna_grid_local.h @@ -0,0 +1,75 @@ +/* -*- c++ -*- ---------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#ifdef COMPUTE_CLASS + +ComputeStyle(sna/grid/local,ComputeSNAGridLocal) + +#else + +#ifndef LMP_COMPUTE_SNA_GRID_LOCAL_H +#define LMP_COMPUTE_SNA_GRID_LOCAL_H + +#include "compute_grid_local.h" + +namespace LAMMPS_NS { + +class ComputeSNAGridLocal : public ComputeGridLocal { + public: + ComputeSNAGridLocal(class LAMMPS *, int, char **); + ~ComputeSNAGridLocal(); + void init(); + void init_list(int, class NeighList *); + void compute_local(); + double memory_usage(); + + private: + int ncoeff; + double **cutsq; + class NeighList *list; + double rcutfac; + double *radelem; + double *wjelem; + int *map; // map types to [0,nelements) + int nelements, chemflag; + class SNA *snaptr; + double cutmax; + int quadraticflag; +}; + +} + +#endif +#endif + +/* ERROR/WARNING messages: + +E: Illegal ... command + +Self-explanatory. Check the input script syntax and compare to the +documentation for the command. You can use -echo screen as a +command-line option when running LAMMPS to see the offending line. + +E: Compute sna/grid/local requires a pair style be defined + +Self-explanatory. + +E: Compute sna/grid/local cutoff is longer than pairwise cutoff + +Self-explanatory. + +W: More than one compute sna/grid/local + +Self-explanatory. + +*/ diff --git a/src/compute_grid_local.cpp b/src/compute_grid_local.cpp new file mode 100644 index 0000000000..8c0f8ff066 --- /dev/null +++ b/src/compute_grid_local.cpp @@ -0,0 +1,253 @@ +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#include "compute_grid_local.h" +#include +#include +#include "atom.h" +#include "update.h" +#include "modify.h" +#include "domain.h" +#include "force.h" +#include "memory.h" +#include "error.h" +#include "comm.h" + +using namespace LAMMPS_NS; + +/* ---------------------------------------------------------------------- */ + +ComputeGridLocal::ComputeGridLocal(LAMMPS *lmp, int narg, char **arg) : + Compute(lmp, narg, arg), gridlocal(nullptr), alocal(nullptr) +{ + if (narg < 6) error->all(FLERR,"Illegal compute grid/local command"); + + local_flag = 1; + size_local_cols = 0; + size_local_rows = 0; + extarray = 0; + + int iarg0 = 3; + int iarg = iarg0; + if (strcmp(arg[iarg],"grid") == 0) { + if (iarg+4 > narg) error->all(FLERR,"Illegal compute grid/local command"); + nx = utils::inumeric(FLERR,arg[iarg+1],false,lmp); + ny = utils::inumeric(FLERR,arg[iarg+2],false,lmp); + nz = utils::inumeric(FLERR,arg[iarg+3],false,lmp); + if (nx <= 0 || ny <= 0 || nz <= 0) + error->all(FLERR,"All grid/local dimensions must be positive"); + iarg += 4; + } else error->all(FLERR,"Illegal compute grid/local command"); + + nargbase = iarg - iarg0; + + size_local_cols_base = 6; + gridlocal_allocated = 0; +} + +/* ---------------------------------------------------------------------- */ + +ComputeGridLocal::~ComputeGridLocal() +{ + if (gridlocal_allocated) { + gridlocal_allocated = 0; + memory->destroy4d_offset(gridlocal,nzlo,nylo,nxlo); + } + memory->destroy(alocal); +} + +/* ---------------------------------------------------------------------- */ + +void ComputeGridLocal::init() +{ +} + +/* ---------------------------------------------------------------------- */ + +void ComputeGridLocal::setup() +{ + set_grid_global(); + set_grid_local(); + allocate(); +} + +/* ---------------------------------------------------------------------- + convert global array indexes to box coords +------------------------------------------------------------------------- */ + +void ComputeGridLocal::grid2x(int ix, int iy, int iz, double *x) +{ + x[0] = ix*delx; + x[1] = iy*dely; + x[2] = iz*delz; + + if (triclinic) domain->lamda2x(x, x); +} + +/* ---------------------------------------------------------------------- + free and reallocate arrays +------------------------------------------------------------------------- */ + +void ComputeGridLocal::allocate() +{ + // allocate local array + + if (gridlocal_allocated) { + gridlocal_allocated = 0; + // MEMORY LEAK!! + // can't seem to free this memory without seg-fault + // printf("Before allocate destroy4d, proc %d %p\n",comm->me,gridlocal); + // memory->destroy4d_offset(gridlocal,nzlo,nylo,nxlo); + // printf("After allocate destroy4d, proc %d %p\n",comm->me,gridlocal); + } + + if (nxlo <= nxhi && nylo <= nyhi && nzlo <= nzhi) { + gridlocal_allocated = 1; + memory->create4d_offset(gridlocal,size_array_cols,nzlo,nzhi,nylo,nyhi, + nxlo,nxhi,"grid:gridlocal"); + } +} + +/* ---------------------------------------------------------------------- + set global grid +------------------------------------------------------------------------- */ + +void ComputeGridLocal::set_grid_global() +{ + // calculate grid layout + + triclinic = domain->triclinic; + + if (triclinic == 0) { + prd = domain->prd; + boxlo = domain->boxlo; + sublo = domain->sublo; + subhi = domain->subhi; + } else { + prd = domain->prd_lamda; + boxlo = domain->boxlo_lamda; + sublo = domain->sublo_lamda; + subhi = domain->subhi_lamda; + } + + double xprd = prd[0]; + double yprd = prd[1]; + double zprd = prd[2]; + + delxinv = nx/xprd; + delyinv = ny/yprd; + delzinv = nz/zprd; + + delx = 1.0/delxinv; + dely = 1.0/delyinv; + delz = 1.0/delzinv; +} + +/* ---------------------------------------------------------------------- + set local subset of grid that I own + n xyz lo/hi = 3d brick that I own (inclusive) +------------------------------------------------------------------------- */ + +void ComputeGridLocal::set_grid_local() +{ + // nx,ny,nz = extent of global grid + // indices into the global grid range from 0 to N-1 in each dim + // if grid point is inside my sub-domain I own it, + // this includes sub-domain lo boundary but excludes hi boundary + // ixyz lo/hi = inclusive lo/hi bounds of global grid sub-brick I own + // if proc owns no grid cells in a dim, then ilo > ihi + // if 2 procs share a boundary a grid point is exactly on, + // the 2 equality if tests insure a consistent decision + // as to which proc owns it + + double xfraclo,xfrachi,yfraclo,yfrachi,zfraclo,zfrachi; + + if (comm->layout != Comm::LAYOUT_TILED) { + xfraclo = comm->xsplit[comm->myloc[0]]; + xfrachi = comm->xsplit[comm->myloc[0]+1]; + yfraclo = comm->ysplit[comm->myloc[1]]; + yfrachi = comm->ysplit[comm->myloc[1]+1]; + zfraclo = comm->zsplit[comm->myloc[2]]; + zfrachi = comm->zsplit[comm->myloc[2]+1]; + } else { + xfraclo = comm->mysplit[0][0]; + xfrachi = comm->mysplit[0][1]; + yfraclo = comm->mysplit[1][0]; + yfrachi = comm->mysplit[1][1]; + zfraclo = comm->mysplit[2][0]; + zfrachi = comm->mysplit[2][1]; + } + + nxlo = static_cast (xfraclo * nx); + if (1.0*nxlo != xfraclo*nx) nxlo++; + nxhi = static_cast (xfrachi * nx); + if (1.0*nxhi == xfrachi*nx) nxhi--; + + nylo = static_cast (yfraclo * ny); + if (1.0*nylo != yfraclo*ny) nylo++; + nyhi = static_cast (yfrachi * ny); + if (1.0*nyhi == yfrachi*ny) nyhi--; + + nzlo = static_cast (zfraclo * nz); + if (1.0*nzlo != zfraclo*nz) nzlo++; + nzhi = static_cast (zfrachi * nz); + if (1.0*nzhi == zfrachi*nz) nzhi--; + + ngridlocal = (nxhi - nxlo + 1) * (nyhi - nylo + 1) * (nzhi - nzlo + 1); + size_local_rows = ngridlocal; + + memory->destroy(alocal); + memory->create(alocal, size_local_rows, size_local_cols, "compute/grid/local:alocal"); + array_local = alocal; + + int igrid = 0; + for (int iz = nzlo; iz <= nzhi; iz++) + for (int iy = nylo; iy <= nyhi; iy++) + for (int ix = nxlo; ix <= nxhi; ix++) { + alocal[igrid][0] = ix; + alocal[igrid][1] = iy; + alocal[igrid][2] = iz; + double xgrid[3]; + grid2x(ix, iy, iz, xgrid); + alocal[igrid][3] = xgrid[0]; + alocal[igrid][4] = xgrid[1]; + alocal[igrid][5] = xgrid[2]; + igrid++; + } +} + +/* ---------------------------------------------------------------------- + copy the 4d gridlocal array values to the 2d local array +------------------------------------------------------------------------- */ + +void ComputeGridLocal::copy_gridlocal_to_local_array() +{ + int igrid = 0; + for (int iz = nzlo; iz <= nzhi; iz++) + for (int iy = nylo; iy <= nyhi; iy++) + for (int ix = nxlo; ix <= nxhi; ix++) { + for (int icol = size_local_cols_base; icol < size_local_cols; icol++) + alocal[igrid][icol] = gridlocal[icol][iz][iy][ix]; + igrid++; + } +} + +/* ---------------------------------------------------------------------- + memory usage of local data +------------------------------------------------------------------------- */ + +double ComputeGridLocal::memory_usage() +{ + int nbytes = size_array_cols*ngridlocal*sizeof(double); // gridlocal + return nbytes; +} diff --git a/src/compute_grid_local.h b/src/compute_grid_local.h new file mode 100644 index 0000000000..b6cd882b2e --- /dev/null +++ b/src/compute_grid_local.h @@ -0,0 +1,69 @@ +/* -*- c++ -*- ---------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#ifndef LMP_COMPUTE_GRID_LOCAL_H +#define LMP_COMPUTE_GRID_LOCAL_H + +#include "compute.h" + +namespace LAMMPS_NS { + +class ComputeGridLocal : public Compute { + public: + + ComputeGridLocal(class LAMMPS *, int, char **); + virtual ~ComputeGridLocal(); + void init(); + void setup(); + virtual void compute_local() = 0; + + double memory_usage(); + + protected: + int nx, ny, nz; // global grid dimensions + int nxlo, nxhi, nylo, nyhi, nzlo, nzhi; // local grid bounds, inclusive + int ngridlocal; // number of local grid points + int nvalues; // number of values per grid point + double ****gridlocal; // local grid + double **alocal; // pointer to Compute::array_local + int triclinic; // triclinic flag + double *boxlo, *prd; // box info (units real/ortho or reduced/tri) + double *sublo, *subhi; // subdomain info (units real/ortho or reduced/tri) + double delxinv,delyinv,delzinv; // inverse grid spacing + double delx,dely,delz; // grid spacing + int nargbase; // number of base class args + double cutmax; // largest cutoff distance + int size_local_cols_base; // number of columns used for coords, etc. + int gridlocal_allocated; // shows if gridlocal allocated + + void allocate(); + void grid2x(int, int, int, double*); // convert global indices to coordinates + void set_grid_global(); // set global grid + void set_grid_local(); // set bounds for local grid + void copy_gridlocal_to_local_array();// copy 4d gridlocal array to 2d local array + private: +}; + +} + +#endif + +/* ERROR/WARNING messages: + +E: Illegal ... command + +Self-explanatory. Check the input script syntax and compare to the +documentation for the command. You can use -echo screen as a +command-line option when running LAMMPS to see the offending line. + +*/ From b2b807f9b92e239864365845d329e72d5645f23f Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Wed, 25 Aug 2021 13:53:31 -0600 Subject: [PATCH 028/585] initial version of AMOEBA/HIPPO force field files --- doc/src/Howto_amoeba.rst | 126 + doc/src/pair_amoeba.rst | 223 + examples/README | 1 + examples/amoeba/amoeba_ubiquitin.key | 17 + examples/amoeba/amoeba_ubiquitin.prm | 11583 +++++++ examples/amoeba/amoeba_water.key | 9 + examples/amoeba/amoeba_water.prm | 159 + examples/amoeba/data.ubiquitin | 31673 ++++++++++++++++++++ examples/amoeba/data.water_box | 1980 ++ examples/amoeba/data.water_dimer.amoeba | 54 + examples/amoeba/data.water_dimer.hippo | 54 + examples/amoeba/data.water_hexamer.amoeba | 90 + examples/amoeba/data.water_hexamer.hippo | 90 + examples/amoeba/hippo_water.key | 9 + examples/amoeba/hippo_water.prm | 319 + examples/amoeba/in.ubiquitin | 105 + examples/amoeba/in.water_box | 106 + examples/amoeba/in.water_dimer | 104 + examples/amoeba/in.water_hexamer | 103 + examples/amoeba/ubiquitin.xyz | 9738 ++++++ examples/amoeba/water_box.xyz | 649 + examples/amoeba/water_dimer.xyz | 7 + examples/amoeba/water_hexamer.xyz | 19 + src/KSPACE/gridcomm.cpp | 83 +- src/KSPACE/gridcomm.h | 19 +- src/KSPACE/msm.cpp | 40 +- src/KSPACE/msm_cg.cpp | 45 +- src/KSPACE/pppm.cpp | 28 +- src/KSPACE/pppm_cg.cpp | 20 +- src/KSPACE/pppm_dipole.cpp | 12 +- src/KSPACE/pppm_dipole_spin.cpp | 12 +- src/KSPACE/pppm_disp.cpp | 88 +- src/KSPACE/pppm_stagger.cpp | 20 +- src/Makefile | 1 + src/angle.cpp | 138 +- src/angle.h | 1 + src/atom.cpp | 14 +- src/atom.h | 10 + src/fix_property_atom.cpp | 223 +- src/fix_property_atom.h | 2 +- src/fix_store.cpp | 195 +- src/fix_store.h | 16 +- src/force.cpp | 15 +- src/force.h | 3 +- src/input.cpp | 2 + src/memory.h | 66 +- src/neighbor.cpp | 18 +- src/pair.h | 6 + src/special.cpp | 234 +- src/special.h | 4 +- tools/README | 1 + tools/tinker2lmp.py | 913 + 52 files changed, 59025 insertions(+), 422 deletions(-) create mode 100644 doc/src/Howto_amoeba.rst create mode 100644 doc/src/pair_amoeba.rst create mode 100644 examples/amoeba/amoeba_ubiquitin.key create mode 100644 examples/amoeba/amoeba_ubiquitin.prm create mode 100644 examples/amoeba/amoeba_water.key create mode 100644 examples/amoeba/amoeba_water.prm create mode 100644 examples/amoeba/data.ubiquitin create mode 100644 examples/amoeba/data.water_box create mode 100644 examples/amoeba/data.water_dimer.amoeba create mode 100644 examples/amoeba/data.water_dimer.hippo create mode 100644 examples/amoeba/data.water_hexamer.amoeba create mode 100644 examples/amoeba/data.water_hexamer.hippo create mode 100644 examples/amoeba/hippo_water.key create mode 100644 examples/amoeba/hippo_water.prm create mode 100644 examples/amoeba/in.ubiquitin create mode 100644 examples/amoeba/in.water_box create mode 100644 examples/amoeba/in.water_dimer create mode 100644 examples/amoeba/in.water_hexamer create mode 100644 examples/amoeba/ubiquitin.xyz create mode 100644 examples/amoeba/water_box.xyz create mode 100644 examples/amoeba/water_dimer.xyz create mode 100644 examples/amoeba/water_hexamer.xyz create mode 100644 tools/tinker2lmp.py diff --git a/doc/src/Howto_amoeba.rst b/doc/src/Howto_amoeba.rst new file mode 100644 index 0000000000..f60220f71b --- /dev/null +++ b/doc/src/Howto_amoeba.rst @@ -0,0 +1,126 @@ +AMOEBA and HIPPO force fields +============================= + +The AMOEBA and HIPPO polarizable force fields were developed by Jay +Ponder's group at U Washington at St Louis. Their implementation in +LAMMPS was done using code provided by the Ponder group from their +`Tinker MD code `_ written in F90. + +NOTE: what version of AMOEBA and HIPPO does LAMMPS implement? + +These force fields can be used when polarization effects are desired +in simulations of water, organic molecules, and biomolecules including +proteins, provided that parameterizations (force field files) are +available for the systems you are interested in. Files in the LAMMPS +potentials with a "amoeba" or "hippo" suffix can be used. The Tinker +distribution and website may have other such files. + +Note that currently, HIPPO can only be used for water systems, but +HIPPO files for a variety of small organic and biomolecules are in +preparation by the Ponder group. They will be included in the LAMMPS +distribution when available. + +The :doc:`pair_style amoeba ` doc page gives a brief +description of the AMOEBA and HIPPO force fields. Further details for +AMOEBA are in these papers: :ref:`(Ren) `, :ref:`(Shi) +`. Further details for HIPPO are in this paper: +:ref:`(Rackers) `. + +---------- + +To use the AMOEBA force field in LAMMPS you should use these commands +appropriately in your input script. The only change needed for a +HIPPO simulation is for the pair_style and pair_coeff commands. +See examples/amoeba for example input scripts. + +.. code-block:: LAMMPS + + units real # required + atom_style hybrid full amoeba + bond_style amoeba + angle_style amoeba + dihedral_style amoeba + fix amtype all property/atom i_amtype ghost yes # fix ID matches read_data command + fix amoeba1 all property/atom & # fix ID (amoeba12) does not matter + i_amgroup i_ired i_xaxis i_yaxis i_zaxis d_pval ghost yes + fix amoeba2 all property/atom i_polaxe + read_data filename fix amtype NULL "Tinker Types" # fix ID matches fix command + pair_coeff * * ../potentials/protein.prm.amoeba ../potentials/protein.key.amoeba # for AMOEBA + pair_coeff * * ../potentials/water.prm.hippo ../potentials/water.key.hippo # for HIPPO + special_bonds lj/coul 0.5 0.5 0.5 one/five yes + +Both AMOEBA and HIPPO use amoeba for bond/angle/dihedral styles, +assuming the molecular system has bonds, angles, or dihedrals. These +style commands must be be used before the data file is read, as the +data file defines the coefficients for the various bond/angle/dihedral +types. The pair_style command can come after the read_data command, +as no pair coefficients are defined in the data file. + +The :doc:`fix property/atom ` commands are required +to create per-atom data used by the AMOEBA/HIPPO force fields, some of +which is defined in the LAMMPS data file. The LAMMPS data file should +be produced as a pre-processing step by the tinker2lmp.py Python +script in tools/amoeba with a command like one of the following. +The tools/amoeba/README file has more details on using this tool. + +.. code-block:: bash + + % python tinker2lmp.py -xyz tinker.xyz -amoeba protein.prm.amoeba -data lmp.data # AMOEBA for non-periodic systems + % python tinker2lmp.py -xyz tinker.xyz -amoeba protein.prm.amoeba -data lmp.data -pbc 10.0 20.0 15.0 # AMOEBA for periodic systems + % python tinker2lmp.py -xyz tinker.xyz -hippo water.prm.hippo -data lmp.data # HIPPO for non-periodic systems + % python tinker2lmp.py -xyz tinker.xyz -hippo water.prm.hippo -data lmp.data -pbc 10.0 20.0 15.0 # HIPPO for periodic systems + +Note that two input files are needed and a LAMMPS data file (lmp.data) +is produced. The data file will have information on Tinker atom types +and AMOEBA/HIPPO force field parameters for bonds, angles, and +dihedrals. + +The first input is an XYZ file listing all the atoms in the +system. + +NOTE: is this a Tinker-augmented-XYZ format or standard? In either +case, how do we suggest LAMMPS users come up with these files? + +The second input is an AMOEBA or HIPPO PRM (force field) file. The +format of these files is defined by Tinker. A few such files are +provided in the LAMMPS potentials directory. Others may be available +in the Tinker distribution or from the Ponder group. + +The pair_coeff command should specify the same PRM file, and +optionally a Tinker-format KEY file. See the :doc:`pair_style amoeba +` doc page for more information about Tinker PRM and KEY +files. + +Finally, the :doc:`special_bonds ` command is used to +set all LJ and Coulombic 1-2, 1-3, 1-4 weighting factors to non-zero +and non-unity values, and to generate a per-atom list of 1-5 neighbors +as well. This is to insure all bond-topology neighbors are included +in the neighbor lists used by AMOEBA/HIPPO. These force fields apply +their own custom weighting factors to all these terms, including the +1-5 neighbors. + +---------- + +These command doc pages have additional details: + +* :doc:`pair_style amoeba or hippo ` +* :doc:`bond_style amoeba ` +* :doc:`angle_style amoeba ` +* :doc:`dihedral_style amoeba ` +* :doc:`fix property/atom ` +* :doc:`special_bonds ` + +---------- + +.. _howto-Ren: + +**(Ren)** Ren and Ponder, J Phys Chem B, 107, 5933 (2003). + +.. _howto-Shi: + +**(Shi)** Shi, Xiz, Znahg, Best, Wu, Ponder, Ren, J Chem Theory Comp, + 9, 4046, 2013. + +.. _howto-Rackers: + +**(Rackers)** Rackers and Ponder, J Chem Phys, 150, 084104 (2010). diff --git a/doc/src/pair_amoeba.rst b/doc/src/pair_amoeba.rst new file mode 100644 index 0000000000..67c8e02557 --- /dev/null +++ b/doc/src/pair_amoeba.rst @@ -0,0 +1,223 @@ +.. index:: pair_style amoeba +.. index:: pair_style hippo + +pair_style amoeba command +========================= + +pair_style hippo command +========================= + +Syntax +"""""" + +.. code-block:: LAMMPS + + pair_style style + +* style = *amoeba* or *hippo* + +Examples +"""""""" + +.. code-block:: LAMMPS + + pair_style amoeba + pair_coeff * * protein.prm.amoeba protein.key.amoeba + +.. code-block:: LAMMPS + + pair_style hippo + pair_coeff * * water.prm.hippo water.key.hippo + + +Additional info +""""""""""""""" + +doc:`Howto amoeba ` +doc:`bond_style amoeba ` +doc:`angle_style amoeba ` +doc:`dihedral_style amoeba ` +examples/amoeba +tools/amoeba +potentials/\*.prm.ameoba +potentials/\*.key.ameoba +potentials/\*.prm.hippo +potentials/\*.key.hippo + +Description +""""""""""" + +NOTE: edit this paragraph however you wish including adding or changing +citations (see bottom of this file) + +The *amoeba* style computes the AMOEBA polarizeable field formulated +by Jay Ponder's group at U Washington at St Louis :ref:`(Ren) +`, :ref:`(Shi) `. The *hippo* style +computes the HIPPO polarizeable force field , an extension to AMOEBA, +formulated by Josh Rackers and collaborators in the Ponder group +:ref:`(Rackers) `. + +These force fields can be used when polarization effects are desired +in simulations of water, organic molecules, and biomolecules including +proteins, provided that parameterizations (force field files) are +available for the systems you are interested in. Files in the LAMMPS +potentials with a "amoeba" or "hippo" suffix can be used. The Tinker +distribution and website may have other such files. + +NOTE: replace these LaTeX formulas with a list of AMOEBA and HIPPO +terms in some simple notation. If desired, a more detailed +mathematical expression for each term could also be included below +the initial 2 formulas. + +The AMOEBA force field can be written as a collection of terms + +.. math:: + + E = 4 \epsilon \left[ \left(\frac{\sigma}{r}\right)^{12} - + \left(\frac{\sigma}{r}\right)^6 \right] + \qquad r < r_c + +:math:`r_c` is the cutoff, blah is the dipole, etc + +The HIPPO force field is similar but alters some of the terms + +.. math:: + + E = 4 \epsilon \left[ \left(\frac{\sigma}{r}\right)^{12} - + \left(\frac{\sigma}{r}\right)^6 \right] + \qquad r < r_c + +:math:`r_c` is the cutoff, blah is the dipole, etc + +NOTE: Add a sentence for each term to explain what physical effects +the FFs are encoding. E.g. The polar term iteratively computes an +induced dipole for each atom, then calculates dipole-dipole +interactions ... + +See the AMOEBA and HIPPO papers for further details. + +.. note:: + + The AMOEBA and HIPPO force fields compute long-range charge, dipole, + and quadrupole interactions (NOTE: also long-range dispersion?). + However, unlike other models with long-range interactions in LAMMPS, + this does not require use of a KSpace style via the + :doc:`kspace_style ` command. That is because for + AMOEBA and HIPPO the long-range computations are intertwined with + the pairwise compuations. So these pair style include both short- + and long-range computations. This means the energy and virial + computed by the pair style as well as the "Pair" timing reported by + LAMMPS will include the long-range components. + +.. note:: + + As explained on the :doc:`Howto amoeba ` doc page, use + of these pair styles to run a simulation with the AMOEBA or HIPPO + force fields requires your input script to use the :doc:`atom_style + hybrid full amoeba ` atom style, AMOEBA versions of + bond/angle/dihedral styles, the :doc:`special_bonds one/five + ` option, and the :doc:`fix property/atom one/five + ` command to define several additional per-atom + properties. The latter requires a "Tinker Types" section be + included in the LAMMPS data file. This can be auto-generated using + the tools/amoeba/tinker2lmp.py Python script. See the :doc:`Howto + amoeba ` doc page and tools/amoeba/README file for + details on using that tool. + +The implementation of the AMOEBA and HIPPO force fields in LAMMPS was +done using code provided by the Ponder group from their `Tinker MD +code `_ written in F90. + +NOTE: what version of AMOEBA and HIPPO does LAMMPS implement? + +---------- + +Only a single pair_coeff command is used with either the *amoeba* and +*hippo* styles which specifies two Tinker files, a PRM and KEY file. + +.. code-block:: LAMMPS + + pair_coeff * * ../potentials/protein.prm.amoeba ../potentials/protein.key.amoeba + pair_coeff * * ../potentials/water.prm.hippo ../potentials/water.key.hippo + +See examples of these files in the potentials directory. + +The format of a PRM file is a collection of sections, each with +multiple lines. These are the sections which LAMMPS recognizes: + +NOTE: need to list these, possibly there are some LAMMPS skips + or which need to be removed for LAMMPS to use the PRM file? + +The format of a KEY file is a series of lines, with one parameter and +its value per line. These are the parameters which LAMMPS recognizes: + +NOTE: need to list these, possibly there are some keywords LAMMPS skips + or which need to be removed for LAMMPS to use the KEY file? + +NOTE: Any other info about PRM and KEY files we should explain +for LAMMPS users here? + +---------- + +Mixing, shift, table, tail correction, restart, rRESPA info +""""""""""""""""""""""""""""""""""""""""""""""""""""""""""" + +These pair styles do not support the :doc:`pair_modify ` +mix, shift, table, and tail options. + +These pair styles do not write their information to :doc:`binary +restart files `, since it is stored in potential files. +Thus, you need to re-specify the pair_style and pair_coeff commands in +an input script that reads a restart file. + +These pair styles can only be used via the *pair* keyword of the +:doc:`run_style respa ` command. They do not support the +*inner*\ , *middle*\ , *outer* keywords. + +---------- + +Restrictions +"""""""""""" + +These pair styles are part of the AMOEBA package. They are only +enabled if LAMMPS was built with that package. See the :doc:`Build +package ` doc page for more info. + +The AMOEBA and HIPPO potential (PRM) and KEY files provided with +LAMMPS in the potentials directory are Tinker files parameterized for +Tinker units. Their numeric parameters are converted by LAMMPS to its +real units :doc:`units `. You can only use these pair styles +with real units. + +These potentials do not yet calculate per-atom energy or virial +contributions. + +---------- + +Related commands +"""""""""""""""" + +:doc:`atom_style amoeba `, `bond_style amoeba +:doc:`, `angle_style amoeba `, +:doc:`dihedral_style amoeba `, `special_bonds +:doc:one/five ` + +Default +""""""" + +none + +---------- + +.. _amoeba-Ren: + +**(Ren)** Ren and Ponder, J Phys Chem B, 107, 5933 (2003). + +.. _amoeba-Shi: + +**(Shi)** Shi, Xiz, Znahg, Best, Wu, Ponder, Ren, J Chem Theory Comp, + 9, 4046, 2013. + +.. _amoeba-Rackers: + +**(Rackers)** Rackers and Ponder, J Chem Phys, 150, 084104 (2010). diff --git a/examples/README b/examples/README index 9e873b49b9..55f157ab5a 100644 --- a/examples/README +++ b/examples/README @@ -59,6 +59,7 @@ sub-directories: accelerate: use of all the various accelerator packages airebo: polyethylene with AIREBO potential +amoeba: small water and bio models with AMOEBA and HIPPO potentials atm: Axilrod-Teller-Muto potential balance: dynamic load balancing, 2d system body: body particles, 2d system diff --git a/examples/amoeba/amoeba_ubiquitin.key b/examples/amoeba/amoeba_ubiquitin.key new file mode 100644 index 0000000000..db0a23c950 --- /dev/null +++ b/examples/amoeba/amoeba_ubiquitin.key @@ -0,0 +1,17 @@ +parameters ./amoeba.prm +verbose +neighbor-list +tau-temperature 1.0 +tau-pressure 2.0 +a-axis 54.99 +b-axis 41.91 +c-axis 41.91 +vdw-cutoff 12.0 +ewald +ewald-alpha 0.4 +pewald-alpha 0.5 +ewald-cutoff 7.0 +#pme-grid 60 45 45 +pme-grid 60 48 48 +pme-order 5 +polar-eps 0.00001 diff --git a/examples/amoeba/amoeba_ubiquitin.prm b/examples/amoeba/amoeba_ubiquitin.prm new file mode 100644 index 0000000000..1ada1036ef --- /dev/null +++ b/examples/amoeba/amoeba_ubiquitin.prm @@ -0,0 +1,11583 @@ + + ############################## + ## ## + ## Force Field Definition ## + ## ## + ############################## + + +forcefield AMOEBA-BIO-2009 + +bond-cubic -2.55 +bond-quartic 3.793125 +angle-cubic -0.014 +angle-quartic 0.000056 +angle-pentic -0.0000007 +angle-sextic 0.000000022 +opbendtype ALLINGER +opbend-cubic -0.014 +opbend-quartic 0.000056 +opbend-pentic -0.0000007 +opbend-sextic 0.000000022 +torsionunit 0.5 +vdwtype BUFFERED-14-7 +radiusrule CUBIC-MEAN +radiustype R-MIN +radiussize DIAMETER +epsilonrule HHG +dielectric 1.0 +polarization MUTUAL +vdw-12-scale 0.0 +vdw-13-scale 0.0 +vdw-14-scale 1.0 +vdw-15-scale 1.0 +mpole-12-scale 0.0 +mpole-13-scale 0.0 +mpole-14-scale 0.4 +mpole-15-scale 1.0 +polar-12-scale 0.0 +polar-13-scale 0.0 +polar-14-scale 1.0 +polar-15-scale 1.0 +polar-12-intra 0.0 +polar-13-intra 0.0 +polar-14-intra 0.5 +polar-15-intra 1.0 +direct-11-scale 0.0 +direct-12-scale 1.0 +direct-13-scale 1.0 +direct-14-scale 1.0 +mutual-11-scale 1.0 +mutual-12-scale 1.0 +mutual-13-scale 1.0 +mutual-14-scale 1.0 + + + ############################# + ## ## + ## Literature References ## + ## ## + ############################# + + +This file contains the 2009 AMOEBA biopolymer force field, with updates +to the original AMOEBA protein parameters made during Fall 2009, and a +beta version of AMOEBA nucleic acid parameters due to Chuanjie Wu + +Y. Shi, Z. Xia, J. Zhang, R. Best, J. W. Ponder and P. Ren, "The Polarizable +Atomic Multipole-Based AMOEBA Force Field for Proteins", J. Chem. Theory +Comput., 9, 4046-4063 (2013) + +P. Ren, C. Wu and J. W. Ponder, "Polarizable Atomic Multipole-Based +Molecular Mechanics for Organic Molecules", J. Chem. Theory Comput., +7, 3143-3161 (2011) + +J. C. Wu, J.-P. Piquemal, R. Chaudret, P. Reinhardt and P. Ren, +"Polarizable Molecular Dynamics Simulation of Zn(II) in Water Using +the AMOEBA Force Field", J. Chem. Theory Comput., 6, 2059-2070 (2010) + +A. Grossfield, P. Ren, J. W. Ponder, "Ion Solvation Thermodynamics from +Simulation with a Polarizable Force Field", J. Am. Chem. Soc., 125, +15671-15682 (2003) + +P. Ren and J. W. Ponder, "Polarizable Atomic Multipole Water Model for +Molecular Mechanics Simulation", J. Phys. Chem. B, 107, 5933-5947 (2003) + +Monovalent ion parameters taken from Zhi Wang, Ph.D. thesis, Department +of Chemistry, Washington University in St. Louis, May 2018; available +from https://dasher.wustl.edu/ponder/ + + + ############################################### + ## ## + ## AMOEBA Protein Force Field Atom Classes ## + ## ## + ## 1 Backbone Amide Nitrogen ## + ## 2 Glycine Alpha Carbon ## + ## 3 Backbone Carbonyl Carbon ## + ## 4 Amide or Guanidinium Hydrogen ## + ## 5 Amide Carbonyl Oxygen ## + ## 6 Methine Hydrogen ## + ## 7 Methine Carbon ## + ## 8 Methyl or Methylene Carbon ## + ## 9 Methyl or Methylene Hydrogen ## + ## 10 Hydroxyl Oxygen ## + ## 11 Hydroxyl Hydrogen ## + ## 12 Sulfide or Disulfide Sulfur ## + ## 13 Sulfhydryl Hydrogen ## + ## 14 Thiolate Sulfur ## + ## 15 Proline Backbone Nitrogen ## + ## 16 Proline Ring Methylene Carbon ## + ## 17 Phenyl Carbon ## + ## 18 Phenyl Hydrogen ## + ## 19 Phenolic Oxygen ## + ## 20 Phenolic Hydrogen ## + ## 21 Phenoxide Oxygen ## + ## 22 Indole Carbon ## + ## 23 Indole CH Hydrogen ## + ## 24 Imidazole or Indole NH Nitrogen ## + ## 25 Imidazole or Indole NH Hydrogen ## + ## 26 Imidazole C=C Carbon ## + ## 27 Imidazole CH Hydrogen ## + ## 28 Imidazole N=C-N Carbon ## + ## 29 Imidazole C=N Nitrogen ## + ## 30 Carboxylate Carbon ## + ## 31 Carboxylate Oxygen ## + ## 32 Carboxylic Acid Carbonyl Oxygen ## + ## 33 Carboxylic Acid Hydroxyl Oxygen ## + ## 34 Carboxylic Acid Hydrogen ## + ## 35 Amine or Ammonium Nitrogen ## + ## 36 Ammonium Hydrogen ## + ## 37 Amine Hydrogen ## + ## 38 Guanidinium Hydrogen ## + ## 39 Guanidinium Carbon ## + ## 40 Acetyl or NMe Methyl Carbon ## + ## 41 N-Terminal Ammonium Nitrogen ## + ## 42 N-Terminal Ammonium Hydrogen ## + ## ## + ############################################### + + + ############################# + ## ## + ## Atom Type Definitions ## + ## ## + ############################# + + +atom 1 1 N "Glycine N" 7 14.003 3 +atom 2 2 CA "Glycine CA" 6 12.000 4 +atom 3 3 C "Glycine C" 6 12.000 3 +atom 4 4 HN "Glycine HN" 1 1.008 1 +atom 5 5 O "Glycine O" 8 15.995 1 +atom 6 6 H "Glycine HA" 1 1.008 1 +atom 7 1 N "Alanine N" 7 14.003 3 +atom 8 7 CA "Alanine CA" 6 12.000 4 +atom 9 3 C "Alanine C" 6 12.000 3 +atom 10 4 HN "Alanine HN" 1 1.008 1 +atom 11 5 O "Alanine O" 8 15.995 1 +atom 12 6 H "Alanine HA" 1 1.008 1 +atom 13 8 C "Alanine CB" 6 12.000 4 +atom 14 9 H "Alanine HB" 1 1.008 1 +atom 15 7 C "Valine CB" 6 12.000 4 +atom 16 6 H "Valine HB" 1 1.008 1 +atom 17 8 C "Valine CG" 6 12.000 4 +atom 18 9 H "Valine HG" 1 1.008 1 +atom 19 8 C "Leucine CB" 6 12.000 4 +atom 20 9 H "Leucine HB" 1 1.008 1 +atom 21 7 C "Leucine CG" 6 12.000 4 +atom 22 6 H "Leucine HG" 1 1.008 1 +atom 23 8 C "Leucine CD" 6 12.000 4 +atom 24 9 H "Leucine HD" 1 1.008 1 +atom 25 7 C "Isoleucine CB" 6 12.000 4 +atom 26 6 H "Isoleucine HB" 1 1.008 1 +atom 27 8 C "Isoleucine CG" 6 12.000 4 +atom 28 9 H "Isoleucine HG" 1 1.008 1 +atom 29 8 C "Isoleucine CG" 6 12.000 4 +atom 30 9 H "Isoleucine HG" 1 1.008 1 +atom 31 8 C "Isoleucine CD" 6 12.000 4 +atom 32 9 H "Isoleucine HD" 1 1.008 1 +atom 33 7 CA "Serine CA" 6 12.000 4 +atom 34 8 C "Serine CB" 6 12.000 4 +atom 35 9 H "Serine HB" 1 1.008 1 +atom 36 10 OH "Serine OG" 8 15.995 2 +atom 37 11 HO "Serine HG" 1 1.008 1 +atom 38 7 C "Threonine CB" 6 12.000 4 +atom 39 6 H "Threonine HB" 1 1.008 1 +atom 40 8 C "Threonine CG" 6 12.000 4 +atom 41 9 H "Threonine HG" 1 1.008 1 +atom 42 10 OH "Threonine O" 8 15.995 2 +atom 43 11 HO "Threonine H" 1 1.008 1 +atom 44 7 CA "Cysteine CA" 6 12.000 4 +atom 45 8 C "Cysteine CB" 6 12.000 4 +atom 46 9 H "Cysteine HB" 1 1.008 1 +atom 47 12 SH "Cysteine SG" 16 31.972 2 +atom 48 13 HS "Cysteine HG" 1 1.008 1 +atom 49 12 SS "Cystine SG" 16 31.972 2 +atom 50 8 C "Cysteine Anion CB" 6 12.000 4 +atom 51 9 H "Cysteine Anion HB" 1 1.008 1 +atom 52 14 S "Cysteine Anion S-" 16 31.972 1 +atom 53 15 N "Proline N" 7 14.003 3 +atom 54 7 CA "Proline CA" 6 12.000 4 +atom 55 3 C "Proline C" 6 12.000 3 +atom 56 5 O "Proline O" 8 15.995 1 +atom 57 6 H "Proline HA" 1 1.008 1 +atom 58 16 C "Proline CB" 6 12.000 4 +atom 59 9 H "Proline HB" 1 1.008 1 +atom 60 16 C "Proline CG" 6 12.000 4 +atom 61 9 H "Proline HG" 1 1.008 1 +atom 62 16 C "Proline CD" 6 12.000 4 +atom 63 6 H "Proline HD" 1 1.008 1 +atom 64 8 C "Phenylalanine CB" 6 12.000 4 +atom 65 9 H "Phenylalanine HB" 1 1.008 1 +atom 66 17 C "Phenylalanine CG" 6 12.000 3 +atom 67 17 C "Phenylalanine CD" 6 12.000 3 +atom 68 18 H "Phenylalanine HD" 1 1.008 1 +atom 69 17 C "Phenylalanine CE" 6 12.000 3 +atom 70 18 H "Phenylalanine HE" 1 1.008 1 +atom 71 17 C "Phenylalanine CZ" 6 12.000 3 +atom 72 18 H "Phenylalanine HZ" 1 1.008 1 +atom 73 8 C "Tyrosine CB" 6 12.000 4 +atom 74 9 H "Tyrosine HB" 1 1.008 1 +atom 75 17 C "Tyrosine CG" 6 12.000 3 +atom 76 17 C "Tyrosine CD" 6 12.000 3 +atom 77 18 H "Tyrosine HD" 1 1.008 1 +atom 78 17 C "Tyrosine CE" 6 12.000 3 +atom 79 18 H "Tyrosine HE" 1 1.008 1 +atom 80 17 C "Tyrosine CZ" 6 12.000 3 +atom 81 19 OH "Tyrosine OH" 8 15.995 2 +atom 82 20 HO "Tyrosine HH" 1 1.008 1 +atom 83 8 C "Tyrosine Anion CB" 6 12.000 4 +atom 84 9 H "Tyrosine Anion HB" 1 1.008 1 +atom 85 17 C "Tyrosine Anion CG" 6 12.000 3 +atom 86 17 C "Tyrosine Anion CD" 6 12.000 3 +atom 87 18 H "Tyrosine Anion HD" 1 1.008 1 +atom 88 17 C "Tyrosine Anion CE" 6 12.000 3 +atom 89 18 H "Tyrosine Anion HE" 1 1.008 1 +atom 90 17 C "Tyrosine Anion CZ" 6 12.000 3 +atom 91 21 O- "Tyrosine Anion O-" 8 15.995 1 +atom 92 8 C "Tryptophan CB" 6 12.000 4 +atom 93 9 H "Tryptophan HB" 1 1.008 1 +atom 94 22 C "Tryptophan CG" 6 12.000 3 +atom 95 22 C "Tryptophan CD1" 6 12.000 3 +atom 96 23 H "Tryptophan HD1" 1 1.008 1 +atom 97 22 C "Tryptophan CD2" 6 12.000 3 +atom 98 24 N "Tryptophan NE1" 7 14.003 3 +atom 99 25 HN "Tryptophan HE1" 1 1.008 1 +atom 100 22 C "Tryptophan CE2" 6 12.000 3 +atom 101 22 C "Tryptophan CE3" 6 12.000 3 +atom 102 23 H "Tryptophan HE3" 1 1.008 1 +atom 103 22 C "Tryptophan CZ2" 6 12.000 3 +atom 104 23 H "Tryptophan HZ2" 1 1.008 1 +atom 105 22 C "Tryptophan CZ3" 6 12.000 3 +atom 106 23 H "Tryptophan HZ3" 1 1.008 1 +atom 107 22 C "Tryptophan CH2" 6 12.000 3 +atom 108 23 H "Tryptophan HH2" 1 1.008 1 +atom 109 8 C "Histidine (+) CB" 6 12.000 4 +atom 110 9 H "Histidine (+) HB" 1 1.008 1 +atom 111 26 C "Histidine (+) CG" 6 12.000 3 +atom 112 24 N "Histidine (+) ND1" 7 14.003 3 +atom 113 25 HN "Histidine (+) HD1" 1 1.008 1 +atom 114 26 C "Histidine (+) CD2" 6 12.000 3 +atom 115 27 H "Histidine (+) HD2" 1 1.008 1 +atom 116 28 C "Histidine (+) CE1" 6 12.000 3 +atom 117 27 H "Histidine (+) HE1" 1 1.008 1 +atom 118 24 N "Histidine (+) NE2" 7 14.003 3 +atom 119 25 HN "Histidine (+) HE2" 1 1.008 1 +atom 120 8 C "Histidine (HD) CB" 6 12.000 4 +atom 121 9 H "Histidine (HD) HB" 1 1.008 1 +atom 122 26 C "Histidine (HD) CG" 6 12.000 3 +atom 123 24 N "Histidine (HD) ND1" 7 14.003 3 +atom 124 25 HN "Histidine (HD) HD1" 1 1.008 1 +atom 125 26 C "Histidine (HD) CD2" 6 12.000 3 +atom 126 27 H "Histidine (HD) HD2" 1 1.008 1 +atom 127 28 C "Histidine (HD) CE1" 6 12.000 3 +atom 128 27 H "Histidine (HD) HE1" 1 1.008 1 +atom 129 29 N "Histidine (HD) NE2" 7 14.003 2 +atom 130 8 C "Histidine (HE) CB" 6 12.000 4 +atom 131 9 H "Histidine (HE) HB" 1 1.008 1 +atom 132 26 C "Histidine (HE) CG" 6 12.000 3 +atom 133 29 N "Histidine (HE) ND1" 7 14.003 2 +atom 134 26 C "Histidine (HE) CD2" 6 12.000 3 +atom 135 27 H "Histidine (HE) HD2" 1 1.008 1 +atom 136 28 C "Histidine (HE) CE1" 6 12.000 3 +atom 137 27 H "Histidine (HE) HE1" 1 1.008 1 +atom 138 24 N "Histidine (HE) NE2" 7 14.003 3 +atom 139 25 HN "Histidine (HE) HE2" 1 1.008 1 +atom 140 8 C "Aspartate CB" 6 12.000 4 +atom 141 9 H "Aspartate HB" 1 1.008 1 +atom 142 30 C "Aspartate CG" 6 12.000 3 +atom 143 31 O "Aspartate OD" 8 15.995 1 +atom 144 8 C "Aspartic Acid CB" 6 12.000 4 +atom 145 9 H "Aspartic Acid HB" 1 1.008 1 +atom 146 30 C "Aspartic Acid CG" 6 12.000 3 +atom 147 32 O "Aspartic Acid OD1" 8 15.995 1 +atom 148 33 OH "Aspartic Acid OD2" 8 15.995 2 +atom 149 34 HO "Aspartic Acid HD2" 1 1.008 1 +atom 150 8 C "Asparagine CB" 6 12.000 4 +atom 151 9 H "Asparagine HB" 1 1.008 1 +atom 152 3 C "Asparagine CG" 6 12.000 3 +atom 153 5 O "Asparagine OD1" 8 15.995 1 +atom 154 1 N "Asparagine ND2" 7 14.003 3 +atom 155 4 HN "Asparagine HD2" 1 1.008 1 +atom 156 8 C "Glutamate CB" 6 12.000 4 +atom 157 9 H "Glutamate HB" 1 1.008 1 +atom 158 8 C "Glutamate CG" 6 12.000 4 +atom 159 9 H "Glutamate HG" 1 1.008 1 +atom 160 30 C "Glutamate CD" 6 12.000 3 +atom 161 31 O "Glutamate OE" 8 15.995 1 +atom 162 8 C "Glutamic Acid CB" 6 12.000 4 +atom 163 9 H "Glutamic Acid HB" 1 1.008 1 +atom 164 8 C "Glutamic Acid CG" 6 12.000 4 +atom 165 9 H "Glutamic Acid HG" 1 1.008 1 +atom 166 30 C "Glutamic Acid CD" 6 12.000 3 +atom 167 32 O "Glutamic Acid OE1" 8 15.995 1 +atom 168 33 OH "Glutamic Acid OE2" 8 15.995 2 +atom 169 34 HO "Glutamic Acid HE2" 1 1.008 1 +atom 170 8 C "Glutamine CB" 6 12.000 4 +atom 171 9 H "Glutamine HB" 1 1.008 1 +atom 172 8 C "Glutamine CG" 6 12.000 4 +atom 173 9 H "Glutamine HG" 1 1.008 1 +atom 174 3 C "Glutamine CD" 6 12.000 3 +atom 175 5 O "Glutamine OE1" 8 15.995 1 +atom 176 1 N "Glutamine NE2" 7 14.003 3 +atom 177 4 HN "Glutamine HE2" 1 1.008 1 +atom 178 8 C "Methionine CB" 6 12.000 4 +atom 179 9 H "Methionine HB" 1 1.008 1 +atom 180 8 C "Methionine CG" 6 12.000 4 +atom 181 9 H "Methionine HG" 1 1.008 1 +atom 182 12 S "Methionine SD" 16 31.972 2 +atom 183 8 C "Methionine CE" 6 12.000 4 +atom 184 9 H "Methionine HE" 1 1.008 1 +atom 185 8 C "Lysine CB" 6 12.000 4 +atom 186 9 H "Lysine HB" 1 1.008 1 +atom 187 8 C "Lysine CG" 6 12.000 4 +atom 188 9 H "Lysine HG" 1 1.008 1 +atom 189 8 C "Lysine CD" 6 12.000 4 +atom 190 9 H "Lysine HD" 1 1.008 1 +atom 191 8 C "Lysine CE" 6 12.000 4 +atom 192 9 H "Lysine HE" 1 1.008 1 +atom 193 35 N "Lysine NZ" 7 14.003 4 +atom 194 36 HN "Lysine HN" 1 1.008 1 +atom 195 8 C "Lysine (Neutral) CB" 6 12.000 4 +atom 196 9 H "Lysine (Neutral) HB" 1 1.008 1 +atom 197 8 C "Lysine (Neutral) CG" 6 12.000 4 +atom 198 9 H "Lysine (Neutral) HG" 1 1.008 1 +atom 199 8 C "Lysine (Neutral) CD" 6 12.011 4 +atom 200 9 H "Lysine (Neutral) HD" 1 1.008 1 +atom 201 8 C "Lysine (Neutral) CE" 6 12.011 4 +atom 202 9 H "Lysine (Neutral) HE" 1 1.008 1 +atom 203 35 N "Lysine (Neutral) NZ" 7 14.007 3 +atom 204 37 HN "Lysine (Neutral) HN" 1 1.008 1 +atom 205 8 C "Arginine CB" 6 12.000 4 +atom 206 9 H "Arginine HB" 1 1.008 1 +atom 207 8 C "Arginine CG" 6 12.000 4 +atom 208 9 H "Arginine HG" 1 1.008 1 +atom 209 8 C "Arginine CD" 6 12.000 4 +atom 210 9 H "Arginine HD" 1 1.008 1 +atom 211 1 N "Arginine NE" 7 14.003 3 +atom 212 38 HN "Arginine HE" 1 1.008 1 +atom 213 39 C "Arginine CZ" 6 12.000 3 +atom 214 1 N "Arginine NH" 7 14.003 3 +atom 215 38 HN "Arginine HH" 1 1.008 1 +atom 216 8 C "Ornithine CB" 6 12.000 4 +atom 217 9 H "Ornithine HB" 1 1.008 1 +atom 218 8 C "Ornithine CG" 6 12.000 4 +atom 219 9 H "Ornithine HG" 1 1.008 1 +atom 220 8 C "Ornithine CD" 6 12.000 4 +atom 221 9 H "Ornithine HD" 1 1.008 1 +atom 222 35 N "Ornithine NE" 7 14.003 4 +atom 223 36 HN "Ornithine HE" 1 1.008 1 +atom 224 40 C "Acetyl Cap CH3" 6 12.000 4 +atom 225 6 H "Acetyl Cap H3C" 1 1.008 1 +atom 226 3 C "Acetyl Cap C" 6 12.000 3 +atom 227 5 O "Acetyl Cap O" 8 15.995 1 +atom 228 1 N "Amide Cap NH2" 7 14.003 3 +atom 229 4 HN "Amide Cap H2N" 1 1.008 1 +atom 230 1 N "N-MeAmide Cap N" 7 14.003 3 +atom 231 4 HN "N-MeAmide Cap HN" 1 1.008 1 +atom 232 40 C "N-MeAmide Cap CH3" 6 12.000 4 +atom 233 6 H "N-MeAmide Cap H3C" 1 1.008 1 +atom 234 41 N "N-Terminal NH3+" 7 14.003 4 +atom 235 42 H "N-Terminal H3N+" 1 1.008 1 +atom 236 35 N "N-Terminal NH2" 7 14.003 3 +atom 237 37 H "N-Terminal H2N" 1 1.008 1 +atom 238 30 C "C-Terminal COO-" 6 12.000 3 +atom 239 31 O "C-Terminal COO-" 8 15.995 1 +atom 240 30 C "C-Terminal COOH" 6 12.000 3 +atom 241 32 O "C-Terminal COOH" 8 15.995 1 +atom 242 33 OH "C-Terminal COOH" 8 15.995 2 +atom 243 34 HO "C-Terminal COOH" 1 1.008 1 +atom 244 41 N "N-Terminal PRO NH2+" 7 14.003 4 +atom 245 42 HN "N-Terminal PRO H2N+" 1 1.008 1 +atom 246 7 CA "N-Terminal PRO CA" 6 12.000 4 +atom 247 3 C "N-Terminal PRO C" 6 12.000 3 +atom 248 5 O "N-Terminal PRO O" 8 15.995 1 +atom 249 6 H "N-Terminal PRO HA" 1 1.008 1 +atom 250 16 C "N-Terminal PRO CD" 6 12.000 4 +atom 251 6 H "N-Terminal PRO HD" 1 1.008 1 +atom 252 43 N* "Adenine N9" 7 14.007 3 +atom 253 44 CB "Adenine C4" 6 12.011 3 +atom 254 44 CB "Adenine C5" 6 12.011 3 +atom 255 45 NB "Adenine N7" 7 14.007 2 +atom 256 46 CK "Adenine C8" 6 12.011 3 +atom 257 47 NC "Adenine N3" 7 14.007 2 +atom 258 48 CQ "Adenine C2" 6 12.011 3 +atom 259 47 NC "Adenine N1" 7 14.007 2 +atom 260 49 CA "Adenine C6" 6 12.011 3 +atom 261 50 H5 "Adenine H2" 1 1.008 1 +atom 262 51 N2 "Adenine N6" 7 14.007 3 +atom 263 52 H "Adenine H61" 1 1.008 1 +atom 264 52 H "Adenine H62" 1 1.008 1 +atom 265 50 H5 "Adenine H8" 1 1.008 1 +atom 266 43 N* "Cytosine N1" 7 14.007 3 +atom 267 53 C "Cytosine C2" 6 12.011 3 +atom 268 47 NC "Cytosine N3" 7 14.007 2 +atom 269 49 CA "Cytosine C4" 6 12.011 3 +atom 270 54 CM "Cytosine C5" 6 12.011 3 +atom 271 54 CM "Cytosine C6" 6 12.011 3 +atom 272 55 O "Cytosine O2" 8 15.999 1 +atom 273 51 N2 "Cytosine N4" 7 14.007 3 +atom 274 52 H "Cytosine H41" 1 1.008 1 +atom 275 52 H "Cytosine H42" 1 1.008 1 +atom 276 56 HA "Cytosine H5" 1 1.008 1 +atom 277 57 H4 "Cytosine H6" 1 1.008 1 +atom 278 43 N* "Guanine N9" 7 14.007 3 +atom 279 44 CB "Guanine C4" 6 12.011 3 +atom 280 44 CB "Guanine C5" 6 12.011 3 +atom 281 45 NB "Guanine N7" 7 14.007 2 +atom 282 46 CK "Guanine C8" 6 12.011 3 +atom 283 47 NC "Guanine N3" 7 14.007 2 +atom 284 49 CA "Guanine C2" 6 12.011 3 +atom 285 58 NA "Guanine N1" 7 14.007 3 +atom 286 53 C "Guanine C6" 6 12.011 3 +atom 287 59 H "Guanine H1" 1 1.008 1 +atom 288 51 N2 "Guanine N2" 7 14.007 3 +atom 289 52 H "Guanine H21" 1 1.008 1 +atom 290 52 H "Guanine H22" 1 1.008 1 +atom 291 55 O "Guanine O6" 8 15.999 1 +atom 292 50 H5 "Guanine H8" 1 1.008 1 +atom 293 43 N* "Thymine N1" 7 14.007 3 +atom 294 53 C "Thymine C2" 6 12.011 3 +atom 295 58 NA "Thymine N3" 7 14.007 3 +atom 296 53 C "Thymine C4" 6 12.011 3 +atom 297 54 CM "Thymine C5" 6 12.011 3 +atom 298 54 CM "Thymine C6" 6 12.011 3 +atom 299 55 O "Thymine O2" 8 15.999 1 +atom 300 59 H "Thymine H3" 1 1.008 1 +atom 301 55 O "Thymine O4" 8 15.999 1 +atom 302 60 CT "Thymine C7" 6 12.011 4 +atom 303 61 HC "Thymine H7" 1 1.008 1 +atom 304 57 H4 "Thymine H6" 1 1.008 1 +atom 305 43 N* "Uracil N1" 7 14.007 3 +atom 306 53 C "Uracil C2" 6 12.011 3 +atom 307 58 NA "Uracil N3" 7 14.007 3 +atom 308 53 C "Uracil C4" 6 12.011 3 +atom 309 54 CM "Uracil C5" 6 12.011 3 +atom 310 54 CM "Uracil C6" 6 12.011 3 +atom 311 55 O "Uracil O2" 8 15.999 1 +atom 312 59 H "Uracil H3" 1 1.008 1 +atom 313 55 O "Uracil O4" 8 15.999 1 +atom 314 56 HA "Uracil H5" 1 1.008 1 +atom 315 57 H4 "Uracil H6" 1 1.008 1 +atom 316 62 OS "Ribose O5' (CU)" 8 15.999 2 +atom 317 60 CT "Ribose C5' (CU)" 6 12.011 4 +atom 318 61 H1 "Ribose H5'1 (CU)" 1 1.008 1 +atom 319 61 H1 "Ribose H5'2 (CU)" 1 1.008 1 +atom 320 63 CT "Ribose C4' (CU)" 6 12.011 4 +atom 321 64 H1 "Ribose H4' (CU)" 1 1.008 1 +atom 322 62 OS "Ribose O4' (CU)" 8 15.999 2 +atom 323 63 CT "Ribose C1' (CU)" 6 12.011 4 +atom 324 65 H2 "Ribose H1' (CU)" 1 1.008 1 +atom 325 63 CT "Ribose C3' (CU)" 6 12.011 4 +atom 326 64 H1 "Ribose H3' (CU)" 1 1.008 1 +atom 327 63 CT "Ribose C2' (CU)" 6 12.011 4 +atom 328 64 H1 "Ribose H2'1 (CU)" 1 1.008 1 +atom 329 66 OH "Ribose O2' (CU)" 8 15.999 2 +atom 330 67 HO "Ribose HO'2 (CU)" 1 1.008 1 +atom 331 62 OS "Ribose O3' (CU)" 8 15.999 2 +atom 332 62 OS "Ribose O5' (AG)" 8 15.999 2 +atom 333 60 CT "Ribose C5' (AG)" 6 12.011 4 +atom 334 61 H1 "Ribose H5'1 (AG)" 1 1.008 1 +atom 335 61 H1 "Ribose H5'2 (AG)" 1 1.008 1 +atom 336 63 CT "Ribose C4' (AG)" 6 12.011 4 +atom 337 64 H1 "Ribose H4' (AG)" 1 1.008 1 +atom 338 68 OS "Ribose O4' (AG)" 8 15.999 2 +atom 339 63 CT "Ribose C1' (AG)" 6 12.011 4 +atom 340 65 H2 "Ribose H1' (AG)" 1 1.008 1 +atom 341 63 CT "Ribose C3' (AG)" 6 12.011 4 +atom 342 64 H1 "Ribose H3' (AG)" 1 1.008 1 +atom 343 63 CT "Ribose C2' (AG)" 6 12.011 4 +atom 344 64 H1 "Ribose H2'1 (AG)" 1 1.008 1 +atom 345 66 OH "Ribose O2' (AG)" 8 15.999 2 +atom 346 67 HO "Ribose HO'2 (AG)" 1 1.008 1 +atom 347 62 OS "Ribose O3' (AG)" 8 15.999 2 +atom 348 62 OS "Deoxyribose O5' (CT)" 8 15.999 2 +atom 349 60 CT "Deoxyribose C5' (CT)" 6 12.011 4 +atom 350 61 H1 "Deoxyribose H5'1 (CT)" 1 1.008 1 +atom 351 61 H1 "Deoxyribose H5'2 (CT)" 1 1.008 1 +atom 352 69 CT "Deoxyribose C4' (CT)" 6 12.011 4 +atom 353 64 H1 "Deoxyribose H4' (CT)" 1 1.008 1 +atom 354 62 OS "Deoxyribose O4' (CT)" 8 15.999 2 +atom 355 69 CT "Deoxyribose C1' (CT)" 6 12.011 4 +atom 356 65 H2 "Deoxyribose H1' (CT)" 1 1.008 1 +atom 357 69 CT "Deoxyribose C3' (CT)" 6 12.011 4 +atom 358 64 H1 "Deoxyribose H3' (CT)" 1 1.008 1 +atom 359 69 CT "Deoxyribose C2' (CT)" 6 12.011 4 +atom 360 64 H1 "Deoxyribose H2'1 (CT)" 1 1.008 1 +atom 361 64 H1 "Deoxyribose H2'2 (CT)" 1 1.008 1 +atom 362 62 OS "Deoxyribose O3' (CT)" 8 15.999 2 +atom 363 62 OS "Deoxyribose O5' (AG)" 8 15.999 2 +atom 364 60 CT "Deoxyribose C5' (AG)" 6 12.011 4 +atom 365 61 H1 "Deoxyribose H5'1 (AG)" 1 1.008 1 +atom 366 61 H1 "Deoxyribose H5'2 (AG)" 1 1.008 1 +atom 367 69 CT "Deoxyribose C4' (AG)" 6 12.011 4 +atom 368 64 H1 "Deoxyribose H4' (AG)" 1 1.008 1 +atom 369 68 OS "Deoxyribose O4' (AG)" 8 15.999 2 +atom 370 69 CT "Deoxyribose C1' (AG)" 6 12.011 4 +atom 371 65 H2 "Deoxyribose H1' (AG)" 1 1.008 1 +atom 372 69 CT "Deoxyribose C3' (AG)" 6 12.011 4 +atom 373 64 H1 "Deoxyribose H3' (AG)" 1 1.008 1 +atom 374 69 CT "Deoxyribose C2' (AG)" 6 12.011 4 +atom 375 64 H1 "Deoxyribose H2'1 (AG)" 1 1.008 1 +atom 376 64 H1 "Deoxyribose H2'2 (AG)" 1 1.008 1 +atom 377 62 OS "Deoxyribose O3' (AG)" 8 15.999 2 +atom 378 70 P "R-Phosphodiester P" 15 30.974 4 +atom 379 71 O2 "R-Phosphodiester OP" 8 15.999 1 +atom 380 62 OH "R-5'-Hydroxyl O5'T" 8 15.999 2 +atom 381 72 HO "R-5'-Hydroxyl H5T" 1 1.008 1 +atom 382 62 OS "R-5'-Phosphate O5'" 8 15.999 2 +atom 383 70 P "R-5'-Phosphate P" 15 30.974 4 +atom 384 71 O2 "R-5'-Phosphate OP" 8 15.999 1 +atom 385 62 OH "R-3'-Hydroxyl O3'T" 8 15.999 2 +atom 386 72 HO "R-3'-Hydroxyl H3T" 1 1.008 1 +atom 387 62 OS "R-3'-Phosphate O3'" 8 15.999 2 +atom 388 70 P "R-3'-Phosphate P" 15 30.974 4 +atom 389 71 O2 "R-3'-Phosphate OP" 8 15.999 1 +atom 390 70 P "D-Phosphodiester P" 15 30.974 4 +atom 391 71 O2 "D-Phosphodiester OP" 8 15.999 1 +atom 392 62 OH "D-5'-Hydroxyl O5'T" 8 15.999 2 +atom 393 72 HO "D-5'-Hydroxyl H5T" 1 1.008 1 +atom 394 62 OS "D-5'-Phosphate O5'" 8 15.999 2 +atom 395 70 P "D-5'-Phosphate P" 15 30.974 4 +atom 396 71 O2 "D-5'-Phosphate OP" 8 15.999 1 +atom 397 62 OH "D-3'-Hydroxyl O3'T" 8 15.999 2 +atom 398 72 HO "D-3'-Hydroxyl H3T" 1 1.008 1 +atom 399 62 OS "D-3'-Phosphate O3'" 8 15.999 2 +atom 400 70 P "D-3'-Phosphate P" 15 30.974 4 +atom 401 71 O2 "D-3'-Phosphate OP" 8 15.999 1 +atom 402 73 O "AMOEBA Water O" 8 15.999 2 +atom 403 74 H "AMOEBA Water H" 1 1.008 1 +atom 404 75 Li+ "Lithium Ion Li+" 3 6.941 0 +atom 405 76 Na+ "Sodium Ion Na+" 11 22.990 0 +atom 406 77 K+ "Potassium Ion K+" 19 39.098 0 +atom 407 78 Rb+ "Rubidium Ion Rb+" 37 85.468 0 +atom 408 79 Cs+ "Cesium Ion Cs+" 55 132.905 0 +atom 409 80 Be+ "Beryllium Ion Be+2" 4 9.012 0 +atom 410 81 Mg+ "Magnesium Ion Mg+2" 12 24.305 0 +atom 411 82 Ca+ "Calcium Ion Ca+2" 20 40.078 0 +atom 412 83 Zn+ "Zinc Ion Zn+2" 30 65.380 0 +atom 413 84 F- "Fluoride Ion F-" 9 18.998 0 +atom 414 85 Cl- "Chloride Ion Cl-" 17 35.453 0 +atom 415 86 Br- "Bromide Ion Br-" 35 79.904 0 +atom 416 87 I- "Iodide Ion I-" 53 126.904 0 + + + ################################ + ## ## + ## Van der Waals Parameters ## + ## ## + ################################ + + +vdw 1 3.7100 0.1100 +vdw 2 3.8200 0.1010 +vdw 3 3.8200 0.1060 +vdw 4 2.5900 0.0220 0.900 +vdw 5 3.3000 0.1120 +vdw 6 2.9400 0.0260 0.910 +vdw 7 3.6500 0.1010 +vdw 8 3.8200 0.1010 +vdw 9 2.9800 0.0240 0.920 +vdw 10 3.4050 0.1100 +vdw 11 2.6550 0.0135 0.910 +vdw 12 3.9100 0.3850 +vdw 13 3.0000 0.0265 0.980 +vdw 14 4.3500 0.3850 +vdw 15 3.7100 0.1100 +vdw 16 3.8200 0.1010 +vdw 17 3.8000 0.0890 +vdw 18 2.9800 0.0260 0.920 +vdw 19 3.4050 0.1100 +vdw 20 2.6550 0.0135 0.910 +vdw 21 3.3200 0.1120 +vdw 22 3.8000 0.1010 +vdw 23 2.9800 0.0260 0.920 +vdw 24 3.7100 0.1100 +vdw 25 2.5900 0.0220 0.900 +vdw 26 3.8000 0.1010 +vdw 27 2.9800 0.0260 0.920 +vdw 28 3.8000 0.1010 +vdw 29 3.7100 0.1100 +vdw 30 3.8200 0.1060 +vdw 31 3.4500 0.1120 +vdw 32 3.3000 0.1120 +vdw 33 3.4050 0.1100 +vdw 34 2.6550 0.0150 0.910 +vdw 35 3.7100 0.1050 +vdw 36 2.4800 0.0180 0.910 +vdw 37 2.7000 0.0200 0.910 +vdw 38 2.4200 0.0200 0.900 +vdw 39 3.6500 0.1010 +vdw 40 3.8200 0.1010 +vdw 41 3.7100 0.1050 +vdw 42 2.4800 0.0180 0.910 +vdw 43 3.6800 0.1050 +vdw 44 3.7800 0.1010 +vdw 45 3.5000 0.1010 +vdw 46 3.7800 0.1010 +vdw 47 3.5000 0.1050 +vdw 48 3.7800 0.1010 +vdw 49 3.7800 0.1010 +vdw 50 2.6000 0.0180 0.910 +vdw 51 3.5000 0.1010 +vdw 52 2.5500 0.0190 0.910 +vdw 53 3.7800 0.1010 +vdw 54 3.7800 0.1010 +vdw 55 3.3000 0.1120 +vdw 56 2.8000 0.0240 0.910 +vdw 57 2.8000 0.0240 0.910 +vdw 58 3.5000 0.1050 +vdw 59 2.3000 0.0101 0.900 +vdw 60 3.8200 0.1010 +vdw 61 2.9800 0.0240 0.920 +vdw 62 3.4050 0.1120 +vdw 63 3.8200 0.1010 +vdw 64 2.9800 0.0240 0.920 +vdw 65 2.9800 0.0240 0.920 +vdw 66 3.4050 0.1100 +vdw 67 2.6550 0.0135 0.910 +vdw 68 3.4050 0.1100 +vdw 69 3.8200 0.1010 +vdw 70 4.4500 0.3900 +vdw 71 3.3600 0.1120 +vdw 72 2.6550 0.0135 0.910 +vdw 73 3.4050 0.1100 +vdw 74 2.6550 0.0135 0.910 +vdw 75 2.2000 0.0660 +vdw 76 2.9550 0.2800 +vdw 77 3.6800 0.3500 +vdw 78 3.9000 0.3800 +vdw 79 4.1400 0.4200 +vdw 80 1.8800 0.0910 +vdw 81 2.9400 0.3000 +vdw 82 3.6300 0.3500 +vdw 83 2.6800 0.2220 +vdw 84 3.4300 0.2500 +vdw 85 4.1200 0.3400 +vdw 86 4.3200 0.4300 +vdw 87 4.6100 0.5200 + + + ##################################### + ## ## + ## Van der Waals Pair Parameters ## + ## ## + ##################################### + + +vdwpr 77 85 4.2360 0.1512 +vdwpr 77 86 4.3790 0.1664 +vdwpr 77 87 4.6360 0.1720 +vdwpr 78 85 4.3150 0.1859 +vdwpr 78 86 4.4480 0.2068 +vdwpr 78 87 4.6900 0.2145 +vdwpr 79 85 4.3450 0.2894 +vdwpr 79 86 4.4750 0.3307 +vdwpr 79 87 4.7110 0.3466 + + + ################################## + ## ## + ## Bond Stretching Parameters ## + ## ## + ################################## + + +bond 1 2 375.00 1.4370 +bond 1 3 482.00 1.3450 +bond 1 4 487.00 1.0280 +bond 1 7 375.00 1.4370 +bond 1 8 374.80 1.4460 +bond 1 38 487.00 1.0280 +bond 1 39 491.40 1.3250 +bond 1 40 375.00 1.4370 +bond 2 3 345.00 1.5090 +bond 2 6 341.00 1.1120 +bond 2 30 345.00 1.5090 +bond 2 35 381.30 1.4610 +bond 2 41 381.30 1.4480 +bond 3 5 662.00 1.2255 +bond 3 7 345.00 1.5090 +bond 3 8 345.00 1.5090 +bond 3 15 482.00 1.3450 +bond 3 40 345.00 1.5090 +bond 6 7 341.00 1.1120 +bond 6 16 341.00 1.1120 +bond 6 40 341.00 1.1120 +bond 7 7 323.00 1.5250 +bond 7 8 323.00 1.5250 +bond 7 10 410.00 1.4130 +bond 7 15 375.00 1.4370 +bond 7 16 323.00 1.5250 +bond 7 30 345.00 1.5090 +bond 7 35 381.30 1.4610 +bond 7 41 381.30 1.4480 +bond 8 8 323.00 1.5250 +bond 8 9 341.00 1.1120 +bond 8 10 410.00 1.4130 +bond 8 12 215.80 1.8050 +bond 8 17 453.20 1.4990 +bond 8 22 345.00 1.5090 +bond 8 26 453.20 1.4930 +bond 8 30 345.00 1.5090 +bond 8 35 381.30 1.4480 +bond 8 14 216.00 1.8225 +bond 9 16 341.00 1.1120 +bond 10 11 548.90 0.9470 +bond 12 12 188.50 2.0190 +bond 12 13 278.40 1.3420 +bond 15 16 375.00 1.4370 +bond 16 16 323.00 1.5247 +bond 16 41 381.30 1.4480 +bond 17 17 471.90 1.3887 +bond 17 18 370.50 1.1000 +bond 17 19 431.60 1.3550 +bond 17 21 680.00 1.2747 +bond 19 20 548.90 0.9470 +bond 22 22 471.90 1.3887 +bond 22 23 370.50 1.1010 +bond 22 24 653.90 1.3550 +bond 24 25 467.60 1.0300 +bond 24 26 653.90 1.3730 +bond 24 28 653.90 1.3520 +bond 26 26 539.60 1.3710 +bond 26 27 370.50 1.0810 +bond 26 29 670.00 1.3740 +bond 27 28 370.50 1.0810 +bond 28 29 670.00 1.3270 +bond 30 31 705.00 1.2553 +bond 30 32 705.00 1.2255 +bond 30 33 431.60 1.3498 +bond 33 34 514.40 0.9737 +bond 35 36 461.90 1.0150 +bond 35 37 515.90 1.0190 +bond 41 42 461.90 1.0150 +bond 43 44 350.90 1.3888 +bond 43 46 470.70 1.3610 +bond 43 49 455.70 1.4430 +bond 43 53 435.20 1.3620 +bond 43 54 437.60 1.3300 +bond 43 63 498.90 1.4350 +bond 43 69 498.90 1.4350 +bond 43 72 575.00 1.0220 +bond 44 44 314.40 1.4223 +bond 44 45 342.20 1.3809 +bond 44 47 415.70 1.3439 +bond 44 49 335.20 1.3900 +bond 44 53 324.70 1.4280 +bond 45 46 588.30 1.2938 +bond 46 50 426.10 1.0820 +bond 47 48 439.00 1.3115 +bond 47 49 489.70 1.3083 +bond 47 53 432.70 1.3600 +bond 48 50 381.30 1.0910 +bond 49 50 402.10 1.0970 +bond 49 51 455.40 1.3516 +bond 49 54 410.30 1.4100 +bond 49 58 377.90 1.3460 +bond 51 52 300.00 1.0170 +bond 51 59 539.40 1.0170 +bond 53 54 420.70 1.4320 +bond 53 55 732.70 1.2320 +bond 53 58 210.70 1.3900 +bond 54 54 654.20 1.3200 +bond 54 56 441.30 1.0710 +bond 54 57 426.60 1.0760 +bond 54 60 292.30 1.4570 +bond 58 59 532.70 1.0480 +bond 60 61 398.50 1.1000 +bond 60 62 484.00 1.4150 +bond 60 63 390.10 1.5130 +bond 60 69 380.10 1.5130 +bond 62 63 484.00 1.4180 +bond 62 69 384.00 1.4180 +bond 62 70 450.10 1.5900 +bond 62 72 557.50 0.9650 +bond 63 63 385.10 1.5130 +bond 63 64 389.50 1.1000 +bond 63 65 392.00 1.1050 +bond 63 66 580.00 1.3750 +bond 63 68 484.00 1.4180 +bond 64 69 389.50 1.1000 +bond 65 69 405.10 1.0917 +bond 66 67 530.50 0.9620 +bond 68 69 384.00 1.4180 +bond 69 69 320.10 1.5130 +bond 70 71 776.90 1.4800 +bond 73 74 556.85 0.9572 + + + ################################ + ## ## + ## Angle Bending Parameters ## + ## ## + ################################ + + +anglep 2 1 3 50.00 122.00 +anglep 2 1 4 32.00 117.00 +anglep 3 1 4 36.00 121.00 +anglep 3 1 7 50.00 122.00 +anglep 3 1 40 50.00 121.00 +anglep 4 1 4 29.50 123.00 +anglep 4 1 7 32.00 117.00 +anglep 4 1 8 13.70 122.40 +anglep 4 1 39 41.70 120.50 +anglep 4 1 40 32.00 117.00 +anglep 8 1 38 13.70 122.40 +anglep 8 1 39 52.50 120.40 +anglep 38 1 38 29.50 120.00 +anglep 38 1 39 41.70 120.50 +angle 1 2 3 55.00 109.80 +angle 1 2 6 55.00 111.00 +angle 1 2 30 61.00 109.60 +angle 3 2 6 39.00 109.50 +angle 3 2 35 75.20 112.10 +angle 3 2 41 75.20 110.70 +angle 6 2 6 40.00 107.60 +angle 6 2 30 39.00 109.50 +angle 6 2 35 59.00 107.78 +angle 6 2 41 59.00 109.30 +anglep 1 3 2 70.00 113.40 +anglep 1 3 5 77.00 124.20 +anglep 1 3 7 70.00 113.40 +anglep 1 3 8 70.00 113.40 +anglep 1 3 40 41.00 113.40 +anglep 2 3 5 80.00 122.40 +anglep 2 3 15 70.00 113.40 +anglep 5 3 7 80.00 122.40 +anglep 5 3 8 80.00 122.40 +anglep 5 3 15 77.00 124.20 +anglep 5 3 40 80.00 122.40 +anglep 7 3 15 70.00 113.40 +anglep 15 3 40 41.00 113.40 +angle 1 7 3 61.00 109.60 +angle 1 7 6 55.00 111.00 +angle 1 7 7 54.00 111.30 +angle 1 7 8 54.00 111.30 +angle 1 7 30 61.00 109.60 +angle 3 7 6 39.00 109.50 +angle 3 7 7 58.00 110.60 +angle 3 7 8 58.00 110.60 +angle 3 7 15 61.00 109.60 +angle 3 7 16 58.00 110.60 +angle 3 7 35 75.20 112.10 +angle 3 7 41 75.20 110.70 +angle 6 7 7 42.00 110.70 +angle 6 7 8 42.00 112.80 +angle 6 7 10 59.00 110.00 108.90 108.70 +angle 6 7 15 55.00 111.00 +angle 6 7 16 42.00 112.80 +angle 6 7 30 39.00 109.50 +angle 6 7 35 59.00 107.78 +angle 6 7 41 59.00 109.30 +angle 7 7 8 48.20 109.50 110.20 111.00 +angle 7 7 10 59.70 107.50 +angle 7 7 30 58.00 110.60 +angle 7 7 35 75.20 109.00 +angle 7 7 41 56.10 108.50 +angle 8 7 8 48.20 109.50 110.20 111.00 +angle 8 7 10 59.70 107.50 +angle 8 7 30 58.00 110.60 +angle 8 7 35 75.20 109.00 +angle 8 7 41 75.20 110.70 +angle 15 7 16 54.00 104.00 +angle 15 7 30 61.00 109.60 +angle 16 7 30 58.00 110.60 +angle 16 7 41 54.00 104.00 +angle 1 8 8 56.10 109.50 +angle 1 8 9 54.60 111.00 +angle 3 8 7 47.60 110.60 +angle 3 8 8 47.60 110.60 +angle 3 8 9 39.00 109.50 +angle 7 8 7 48.20 109.50 110.20 111.00 +angle 7 8 8 48.20 109.50 110.20 111.00 +angle 7 8 9 42.00 110.70 +angle 7 8 10 59.70 107.50 +angle 7 8 12 53.20 108.00 109.50 110.10 +angle 7 8 17 38.90 110.60 +angle 7 8 22 48.20 109.50 110.20 111.00 +angle 7 8 26 38.80 112.70 +angle 7 8 30 47.60 110.60 +angle 7 8 14 53.20 112.73 +angle 8 8 8 48.20 109.50 110.20 111.00 +angle 8 8 9 42.00 110.70 +angle 8 8 12 53.20 108.00 109.50 110.10 +angle 8 8 30 47.60 110.60 +angle 8 8 35 56.10 109.50 +angle 9 8 9 40.00 107.80 +angle 9 8 10 59.00 110.00 108.90 108.70 +angle 9 8 12 53.20 110.80 110.80 108.00 +angle 9 8 17 39.60 109.50 109.30 110.40 +angle 9 8 22 61.20 109.80 109.30 110.70 +angle 9 8 26 39.60 109.50 +angle 9 8 30 39.00 109.50 +angle 9 8 35 59.00 109.30 +angle 9 8 14 35.00 109.98 +angle 7 10 11 54.00 106.80 +angle 8 10 11 54.00 106.80 +angle 8 12 8 60.40 95.90 +angle 8 12 12 71.90 101.80 +angle 8 12 13 46.80 96.00 +anglep 3 15 7 50.00 122.00 +anglep 3 15 16 50.00 122.00 +anglep 7 15 16 54.70 112.50 +angle 6 16 6 40.00 107.80 +angle 6 16 15 55.00 111.00 +angle 6 16 16 42.00 110.70 +angle 6 16 41 55.00 111.00 +angle 7 16 9 42.00 110.70 +angle 7 16 16 48.20 104.00 +angle 9 16 9 40.00 107.80 +angle 9 16 16 42.00 110.70 +angle 15 16 16 54.00 104.00 +angle 16 16 16 48.20 104.00 +angle 16 16 41 54.00 104.00 +anglep 8 17 17 33.80 122.30 +anglep 17 17 17 54.70 121.70 +anglep 17 17 18 35.30 120.00 120.50 0.00 +anglep 17 17 19 43.20 120.00 +anglep 17 17 21 60.00 123.57 +angle 17 19 20 25.90 109.00 +anglep 8 22 22 61.90 127.00 +anglep 22 22 22 63.30 120.00 +anglep 22 22 23 35.30 128.00 +anglep 22 22 24 47.50 109.00 +anglep 23 22 24 86.30 122.50 +anglep 22 24 22 86.30 109.00 +anglep 22 24 25 35.30 125.50 +anglep 25 24 26 35.30 125.50 +anglep 25 24 28 35.30 125.50 +anglep 26 24 28 86.30 110.80 +anglep 8 26 24 36.00 122.00 +anglep 8 26 26 36.00 131.00 +anglep 8 26 29 36.00 122.00 +anglep 24 26 26 47.50 104.70 +anglep 24 26 29 28.80 111.50 +anglep 24 26 27 38.10 122.50 +anglep 26 26 27 35.30 128.00 +anglep 26 26 29 47.50 110.50 +anglep 27 26 29 38.10 122.50 +anglep 24 28 24 28.80 110.30 +anglep 24 28 27 38.10 122.50 +anglep 24 28 29 28.80 112.20 +anglep 27 28 29 38.10 122.50 +angle 26 29 28 86.30 104.30 +anglep 2 30 31 80.00 122.40 +anglep 2 30 32 80.00 122.40 +anglep 2 30 33 111.50 110.30 +anglep 7 30 31 80.00 122.40 +anglep 7 30 32 80.00 122.40 +anglep 7 30 33 111.50 110.30 +anglep 8 30 31 80.00 122.40 +anglep 8 30 32 80.00 122.40 +angle 8 30 33 111.50 110.30 +anglep 31 30 31 57.60 134.00 +anglep 32 30 33 122.30 121.50 +angle 30 33 34 49.60 108.70 +angle 2 35 37 43.20 107.50 +angle 7 35 37 43.20 107.50 +angle 8 35 36 43.20 110.90 +angle 8 35 37 43.16 108.10 110.90 +angle 36 35 36 43.50 107.00 +angle 37 35 37 34.50 106.40 107.10 +anglep 1 39 1 28.80 120.00 +angle 1 40 6 55.00 111.00 +angle 3 40 6 39.00 109.50 +angle 6 40 6 40.00 107.80 +angle 2 41 42 43.20 108.50 +angle 7 41 16 54.70 112.50 +angle 7 41 42 43.20 108.50 +angle 16 41 42 43.20 110.90 +angle 42 41 42 43.20 105.40 +anglep 44 43 46 89.50 109.95 +anglep 44 43 49 82.10 123.90 +anglep 44 43 63 82.10 122.40 +anglep 44 43 69 82.10 122.40 +anglep 46 43 49 73.30 125.50 +anglep 46 43 63 73.30 127.30 +anglep 46 43 69 73.30 127.30 +anglep 53 43 54 88.10 121.00 +anglep 53 43 63 86.10 117.00 +anglep 53 43 69 86.10 117.00 +anglep 54 43 63 84.00 122.00 +anglep 54 43 69 84.00 122.00 +anglep 63 43 72 45.90 105.10 +anglep 69 43 72 45.90 105.10 +anglep 72 43 72 45.40 102.20 +anglep 43 44 44 84.00 107.00 +anglep 43 44 47 79.20 119.20 +anglep 44 44 45 87.20 112.10 +anglep 44 44 47 78.80 133.70 +anglep 44 44 49 76.90 121.00 +anglep 44 44 53 88.70 120.40 +anglep 45 44 49 87.70 126.90 +anglep 45 44 53 89.40 127.50 +angle 44 45 46 109.80 100.70 +anglep 43 46 45 83.73 110.60 +anglep 43 46 50 39.24 122.40 +anglep 45 46 50 35.30 127.00 +angle 44 47 48 95.91 115.00 +angle 44 47 49 89.47 111.50 +angle 48 47 49 125.64 114.80 +angle 49 47 53 66.62 115.00 +anglep 47 48 47 88.19 132.60 +anglep 47 48 50 39.32 113.65 +anglep 43 49 50 63.30 108.00 +anglep 44 49 47 69.11 118.50 +anglep 44 49 51 56.60 121.80 +anglep 47 49 51 68.40 118.20 +anglep 47 49 54 88.76 125.00 +anglep 47 49 58 55.82 125.80 +anglep 50 49 50 40.81 111.10 +anglep 51 49 54 80.82 117.50 +anglep 51 49 58 89.11 114.10 +anglep 49 51 52 50.23 118.00 +anglep 49 51 59 50.23 118.00 +anglep 52 51 52 27.64 121.00 +anglep 59 51 59 27.64 121.00 +anglep 43 53 47 88.10 116.55 +anglep 43 53 55 85.90 115.00 +anglep 43 53 58 81.10 119.10 +anglep 44 53 55 88.40 128.50 +anglep 44 53 58 88.70 115.50 +anglep 47 53 55 80.70 128.50 +anglep 54 53 55 49.60 127.00 +anglep 54 53 58 68.80 112.00 +anglep 55 53 58 80.70 120.00 +anglep 43 54 54 89.30 117.80 +anglep 43 54 57 35.70 115.70 +anglep 49 54 54 81.80 113.70 +anglep 49 54 56 38.80 123.10 +anglep 53 54 54 69.20 114.00 +anglep 53 54 56 39.50 121.30 +anglep 53 54 60 35.60 121.08 +anglep 54 54 56 31.90 124.70 +anglep 54 54 57 31.90 126.50 +anglep 54 54 60 30.00 126.21 +anglep 49 58 53 80.70 127.00 +anglep 49 58 59 30.60 117.00 +anglep 53 58 53 36.60 126.00 +anglep 53 58 59 47.80 117.00 +angle 54 60 61 68.10 108.85 +angle 61 60 61 34.50 109.00 +angle 61 60 62 51.50 110.00 +angle 61 60 63 38.00 109.00 +angle 61 60 69 38.00 109.50 +angle 62 60 63 75.00 113.00 +angle 62 60 69 75.00 113.00 +angle 60 62 70 80.30 110.80 +angle 60 62 72 55.30 104.00 +angle 63 62 63 88.70 107.50 +angle 63 62 70 80.30 110.80 +angle 63 62 72 55.30 102.15 +angle 69 62 69 88.70 108.00 +angle 69 62 70 80.30 110.80 +angle 69 62 72 55.30 102.15 +angle 43 63 62 35.50 110.00 +angle 43 63 63 40.90 102.00 +angle 43 63 65 50.60 108.00 +angle 43 63 68 35.50 110.00 +angle 60 63 62 65.00 110.00 +angle 60 63 63 50.00 109.35 +angle 60 63 64 38.20 111.00 +angle 60 63 68 65.00 110.00 +angle 62 63 63 88.00 108.50 +angle 62 63 64 54.10 111.80 +angle 62 63 65 55.30 109.30 +angle 63 63 63 60.00 109.35 +angle 63 63 64 38.20 109.00 +angle 63 63 65 36.00 112.60 +angle 63 63 66 88.00 108.50 +angle 63 63 68 88.00 108.50 +angle 64 63 64 35.20 108.00 +angle 64 63 66 54.10 111.00 +angle 64 63 68 54.10 111.80 +angle 65 63 65 32.80 111.10 +angle 65 63 68 55.30 109.30 +angle 63 66 67 55.30 101.15 +angle 63 68 63 88.70 107.50 +angle 69 68 69 88.70 108.00 +angle 43 69 62 35.50 118.00 +angle 43 69 65 52.60 106.66 +angle 43 69 68 35.50 109.00 +angle 43 69 69 40.90 111.00 +angle 60 69 62 65.00 110.00 +angle 60 69 63 65.00 110.00 +angle 60 69 64 38.20 111.00 +angle 60 69 68 65.00 110.00 +angle 60 69 69 50.00 109.35 +angle 62 69 64 54.10 111.80 +angle 62 69 65 55.30 109.30 +angle 62 69 69 88.00 110.00 +angle 64 69 64 25.20 108.00 +angle 64 69 68 54.10 111.80 +angle 64 69 69 38.20 109.00 +angle 65 69 65 35.50 110.60 +angle 65 69 68 55.30 109.30 +angle 65 69 69 36.00 112.60 +angle 68 69 69 88.00 110.00 +angle 69 69 69 60.00 109.35 +angle 62 70 62 65.58 97.00 +angle 62 70 71 75.86 110.00 +angle 71 70 71 89.88 121.20 +angle 74 73 74 48.70 108.50 + + + ############################### + ## ## + ## Stretch-Bend Parameters ## + ## ## + ############################### + + +strbnd 2 1 3 7.20 7.20 +strbnd 2 1 4 4.30 4.30 +strbnd 3 1 4 4.30 4.30 +strbnd 3 1 7 7.20 7.20 +strbnd 3 1 40 7.20 7.20 +strbnd 4 1 7 4.30 4.30 +strbnd 4 1 8 4.30 4.30 +strbnd 4 1 39 4.30 4.30 +strbnd 38 1 39 4.30 4.30 +strbnd 4 1 40 4.30 4.30 +strbnd 8 1 38 4.30 4.30 +strbnd 8 1 39 7.20 7.20 +strbnd 1 2 3 18.70 18.70 +strbnd 1 2 6 11.50 11.50 +strbnd 1 2 30 18.70 18.70 +strbnd 3 2 6 11.50 11.50 +strbnd 3 2 35 18.70 18.70 +strbnd 3 2 41 18.70 18.70 +strbnd 6 2 30 11.50 11.50 +strbnd 6 2 35 11.50 11.50 +strbnd 6 2 41 11.50 11.50 +strbnd 1 3 2 18.70 18.70 +strbnd 1 3 5 18.70 18.70 +strbnd 1 3 7 18.70 18.70 +strbnd 1 3 8 18.70 18.70 +strbnd 1 3 40 18.70 18.70 +strbnd 2 3 5 18.70 18.70 +strbnd 2 3 15 18.70 18.70 +strbnd 5 3 7 18.70 18.70 +strbnd 5 3 8 18.70 18.70 +strbnd 5 3 15 18.70 18.70 +strbnd 5 3 40 18.70 18.70 +strbnd 7 3 15 18.70 18.70 +strbnd 15 3 40 18.70 18.70 +strbnd 1 7 3 18.70 18.70 +strbnd 1 7 6 11.50 11.50 +strbnd 1 7 7 18.70 18.70 +strbnd 1 7 8 18.70 18.70 +strbnd 1 7 30 18.70 18.70 +strbnd 3 7 6 11.50 11.50 +strbnd 3 7 7 18.70 18.70 +strbnd 3 7 8 18.70 18.70 +strbnd 3 7 15 18.70 18.70 +strbnd 3 7 16 18.70 18.70 +strbnd 3 7 35 18.70 18.70 +strbnd 3 7 41 18.70 18.70 +strbnd 6 7 7 11.50 11.50 +strbnd 6 7 8 11.50 11.50 +strbnd 6 7 10 11.50 11.50 +strbnd 6 7 15 11.50 11.50 +strbnd 6 7 16 11.50 11.50 +strbnd 6 7 30 11.50 11.50 +strbnd 6 7 35 11.50 11.50 +strbnd 6 7 41 11.50 11.50 +strbnd 7 7 8 18.70 18.70 +strbnd 7 7 10 18.70 18.70 +strbnd 7 7 30 18.70 18.70 +strbnd 7 7 41 18.70 18.70 +strbnd 8 7 8 18.70 18.70 +strbnd 8 7 10 18.70 18.70 +strbnd 8 7 30 18.70 18.70 +strbnd 8 7 41 18.70 18.70 +strbnd 15 7 16 18.70 18.70 +strbnd 15 7 30 18.70 18.70 +strbnd 16 7 30 18.70 18.70 +strbnd 16 7 41 18.70 18.70 +strbnd 1 8 8 18.70 18.70 +strbnd 1 8 9 11.50 11.50 +strbnd 3 8 7 18.70 18.70 +strbnd 3 8 8 18.70 18.70 +strbnd 3 8 9 11.50 11.50 +strbnd 7 8 7 18.70 18.70 +strbnd 7 8 8 18.70 18.70 +strbnd 7 8 9 11.50 11.50 +strbnd 7 8 10 18.70 18.70 +strbnd 7 8 12 18.70 18.70 +strbnd 7 8 17 18.70 18.70 +strbnd 7 8 22 18.70 18.70 +strbnd 7 8 26 18.70 18.70 +strbnd 7 8 30 18.70 18.70 +strbnd 7 8 14 18.70 18.70 +strbnd 8 8 8 18.70 18.70 +strbnd 8 8 9 11.50 11.50 +strbnd 8 8 12 18.70 18.70 +strbnd 8 8 30 18.70 18.70 +strbnd 8 8 35 18.70 18.70 +strbnd 9 8 10 11.50 11.50 +strbnd 9 8 12 11.50 11.50 +strbnd 9 8 17 11.50 11.50 +strbnd 9 8 22 11.50 11.50 +strbnd 9 8 26 11.50 11.50 +strbnd 9 8 30 11.50 11.50 +strbnd 9 8 35 11.50 11.50 +strbnd 7 10 11 12.95 12.95 +strbnd 8 10 11 12.95 12.95 +strbnd 8 12 8 -5.75 -5.75 +strbnd 8 12 12 -5.75 -5.75 +strbnd 8 12 13 1.45 1.45 +strbnd 3 15 7 7.20 7.20 +strbnd 3 15 16 7.20 7.20 +strbnd 7 15 16 7.20 7.20 +strbnd 6 16 15 11.50 11.50 +strbnd 6 16 16 11.50 11.50 +strbnd 6 16 41 11.50 11.50 +strbnd 7 16 9 11.50 11.50 +strbnd 7 16 16 18.70 18.70 +strbnd 9 16 16 11.50 11.50 +strbnd 15 16 16 18.70 18.70 +strbnd 16 16 16 18.70 18.70 +strbnd 16 16 41 18.70 18.70 +strbnd 8 17 17 18.70 18.70 +strbnd 17 17 17 18.70 18.70 +strbnd 17 17 18 11.50 11.50 +strbnd 17 17 19 18.70 18.70 +strbnd 17 17 21 18.70 18.70 +strbnd 17 19 20 12.95 12.95 +strbnd 8 22 22 18.70 18.70 +strbnd 22 22 22 18.70 18.70 +strbnd 22 22 23 11.50 11.50 +strbnd 22 22 24 18.70 18.70 +strbnd 23 22 24 11.50 11.50 +strbnd 22 24 22 14.40 14.40 +strbnd 22 24 25 4.30 4.30 +strbnd 25 24 26 4.30 4.30 +strbnd 25 24 28 4.30 4.30 +strbnd 26 24 28 14.40 14.40 +strbnd 8 26 24 18.70 18.70 +strbnd 8 26 26 18.70 18.70 +strbnd 8 26 29 18.70 18.70 +strbnd 24 26 26 18.70 18.70 +strbnd 24 26 29 18.70 18.70 +strbnd 24 26 27 11.50 11.50 +strbnd 26 26 27 11.50 11.50 +strbnd 26 26 29 18.70 18.70 +strbnd 27 26 29 11.50 11.50 +strbnd 24 28 24 18.70 18.70 +strbnd 24 28 27 11.50 11.50 +strbnd 24 28 29 18.70 18.70 +strbnd 27 28 29 11.50 11.50 +strbnd 26 29 28 14.40 14.40 +strbnd 2 30 31 18.70 18.70 +strbnd 2 30 32 18.70 18.70 +strbnd 2 30 33 18.70 18.70 +strbnd 7 30 31 18.70 18.70 +strbnd 7 30 32 18.70 18.70 +strbnd 7 30 33 18.70 18.70 +strbnd 8 30 31 18.70 18.70 +strbnd 8 30 32 18.70 18.70 +strbnd 8 30 33 18.70 18.70 +strbnd 31 30 31 18.70 18.70 +strbnd 32 30 33 18.70 18.70 +strbnd 2 35 37 4.30 4.30 +strbnd 7 35 37 4.30 4.30 +strbnd 8 35 36 4.30 4.30 +strbnd 8 35 37 4.30 4.30 +strbnd 1 39 1 18.70 18.70 +strbnd 1 40 6 11.50 11.50 +strbnd 3 40 6 11.50 11.50 +strbnd 2 41 42 4.30 4.30 +strbnd 7 41 16 7.20 7.20 +strbnd 7 41 42 4.30 4.30 +strbnd 16 41 42 4.30 4.30 +strbnd 44 43 46 14.40 14.40 +strbnd 44 43 49 14.40 14.40 +strbnd 44 43 63 14.40 14.40 +strbnd 44 43 69 14.40 14.40 +strbnd 46 43 49 14.40 14.40 +strbnd 46 43 63 14.40 14.40 +strbnd 46 43 69 14.40 14.40 +strbnd 53 43 54 14.40 14.40 +strbnd 53 43 63 14.40 14.40 +strbnd 53 43 69 14.40 14.40 +strbnd 54 43 63 14.40 14.40 +strbnd 54 43 69 14.40 14.40 +strbnd 63 43 72 4.30 4.30 +strbnd 69 43 72 4.30 4.30 +strbnd 43 44 44 18.70 18.70 +strbnd 43 44 47 18.70 18.70 +strbnd 44 44 45 18.70 18.70 +strbnd 44 44 47 18.70 18.70 +strbnd 44 44 49 18.70 18.70 +strbnd 44 44 53 18.70 18.70 +strbnd 45 44 49 18.70 18.70 +strbnd 45 44 53 18.70 18.70 +strbnd 44 45 46 14.40 14.40 +strbnd 43 46 45 18.70 18.70 +strbnd 43 46 50 11.50 11.50 +strbnd 45 46 50 11.50 11.50 +strbnd 44 47 48 14.40 14.40 +strbnd 44 47 49 14.40 14.40 +strbnd 48 47 49 14.40 14.40 +strbnd 49 47 53 14.40 14.40 +strbnd 47 48 47 18.70 18.70 +strbnd 47 48 50 11.50 11.50 +strbnd 43 49 50 11.50 11.50 +strbnd 44 49 47 18.70 18.70 +strbnd 44 49 51 18.70 18.70 +strbnd 47 49 51 18.70 18.70 +strbnd 47 49 54 18.70 18.70 +strbnd 47 49 58 18.70 18.70 +strbnd 51 49 54 18.70 18.70 +strbnd 51 49 58 18.70 18.70 +strbnd 49 51 52 4.30 4.30 +strbnd 49 51 59 4.30 4.30 +strbnd 43 53 47 18.70 18.70 +strbnd 43 53 55 18.70 18.70 +strbnd 43 53 58 18.70 18.70 +strbnd 44 53 55 18.70 18.70 +strbnd 44 53 58 18.70 18.70 +strbnd 47 53 55 18.70 18.70 +strbnd 54 53 55 18.70 18.70 +strbnd 54 53 58 18.70 18.70 +strbnd 55 53 58 18.70 18.70 +strbnd 43 54 54 18.70 18.70 +strbnd 43 54 57 11.50 11.50 +strbnd 49 54 54 18.70 18.70 +strbnd 49 54 56 11.50 11.50 +strbnd 53 54 54 18.70 18.70 +strbnd 53 54 56 11.50 11.50 +strbnd 53 54 60 18.70 18.70 +strbnd 54 54 56 11.50 11.50 +strbnd 54 54 57 11.50 11.50 +strbnd 54 54 60 18.70 18.70 +strbnd 49 58 53 7.20 7.20 +strbnd 49 58 59 4.30 4.30 +strbnd 53 58 53 7.20 7.20 +strbnd 53 58 59 4.30 4.30 +strbnd 54 60 61 11.50 11.50 +strbnd 61 60 62 11.50 11.50 +strbnd 61 60 63 11.50 11.50 +strbnd 61 60 69 11.50 11.50 +strbnd 62 60 63 18.70 18.70 +strbnd 62 60 69 18.70 18.70 +strbnd 60 62 70 14.40 14.40 +strbnd 60 62 72 12.95 12.95 +strbnd 63 62 63 14.40 14.40 +strbnd 63 62 70 14.40 14.40 +strbnd 63 62 72 12.95 12.95 +strbnd 69 62 69 14.40 14.40 +strbnd 69 62 70 14.40 14.40 +strbnd 69 62 72 12.95 12.95 +strbnd 43 63 62 18.70 18.70 +strbnd 43 63 63 18.70 18.70 +strbnd 43 63 65 11.50 11.50 +strbnd 43 63 68 18.70 18.70 +strbnd 60 63 62 18.70 18.70 +strbnd 60 63 63 18.70 18.70 +strbnd 60 63 64 11.50 11.50 +strbnd 60 63 68 18.70 18.70 +strbnd 62 63 63 18.70 18.70 +strbnd 62 63 64 11.50 11.50 +strbnd 62 63 65 11.50 11.50 +strbnd 63 63 63 18.70 18.70 +strbnd 63 63 64 11.50 11.50 +strbnd 63 63 65 11.50 11.50 +strbnd 63 63 66 18.70 18.70 +strbnd 63 63 68 18.70 18.70 +strbnd 64 63 66 11.50 11.50 +strbnd 64 63 68 11.50 11.50 +strbnd 65 63 68 11.50 11.50 +strbnd 43 69 62 18.70 18.70 +strbnd 43 69 65 11.50 11.50 +strbnd 43 69 68 18.70 18.70 +strbnd 43 69 69 18.70 18.70 +strbnd 60 69 62 18.70 18.70 +strbnd 60 69 63 18.70 18.70 +strbnd 60 69 64 11.50 11.50 +strbnd 60 69 68 18.70 18.70 +strbnd 60 69 69 18.70 18.70 +strbnd 62 69 64 11.50 11.50 +strbnd 62 69 65 11.50 11.50 +strbnd 62 69 69 18.70 18.70 +strbnd 64 69 68 11.50 11.50 +strbnd 64 69 69 11.50 11.50 +strbnd 65 69 68 11.50 11.50 +strbnd 65 69 69 11.50 11.50 +strbnd 68 69 69 18.70 18.70 +strbnd 69 69 69 18.70 18.70 +strbnd 62 70 62 14.40 14.40 +strbnd 62 70 71 14.40 14.40 +strbnd 71 70 71 14.40 14.40 + + + ############################### + ## ## + ## Urey-Bradley Parameters ## + ## ## + ############################### + + +ureybrad 74 73 74 -7.60 1.5537 + + + #################################### + ## ## + ## Out-of-Plane Bend Parameters ## + ## ## + #################################### + + +opbend 2 1 0 0 41.70 +opbend 3 1 0 0 70.50 +opbend 4 1 0 0 12.90 +opbend 7 1 0 0 41.70 +opbend 8 1 0 0 0.70 +opbend 38 1 0 0 12.90 +opbend 39 1 0 0 3.60 +opbend 40 1 0 0 41.70 +opbend 1 3 0 0 107.90 +opbend 2 3 0 0 49.60 +opbend 5 3 0 0 54.00 +opbend 7 3 0 0 49.60 +opbend 8 3 0 0 20.90 +opbend 15 3 0 0 49.60 +opbend 40 3 0 0 49.60 +opbend 3 15 0 0 14.40 +opbend 7 15 0 0 14.40 +opbend 16 15 0 0 14.40 +opbend 40 15 0 0 14.40 +opbend 8 17 0 0 14.40 +opbend 17 17 0 0 14.40 +opbend 18 17 0 0 15.10 +opbend 19 17 0 0 14.40 +opbend 21 17 0 0 14.40 +opbend 8 22 0 0 14.40 +opbend 22 22 0 0 14.40 +opbend 23 22 0 0 15.10 +opbend 24 22 0 0 14.40 +opbend 22 24 0 0 34.50 +opbend 25 24 0 0 12.90 +opbend 26 24 0 0 15.10 +opbend 28 24 0 0 15.10 +opbend 8 26 0 0 14.40 +opbend 24 26 0 0 14.40 +opbend 26 26 0 0 14.40 +opbend 27 26 0 0 14.40 +opbend 29 26 0 0 14.40 +opbend 24 28 0 0 14.40 +opbend 27 28 0 0 14.40 +opbend 29 28 0 0 14.40 +opbend 2 30 0 0 121.60 +opbend 7 30 0 0 121.60 +opbend 8 30 0 0 121.60 +opbend 31 30 0 0 118.70 +opbend 32 30 0 0 118.70 +opbend 33 30 0 0 122.30 +opbend 1 39 0 0 1.40 +opbend 44 43 0 0 15.10 +opbend 46 43 0 0 15.10 +opbend 49 43 0 0 133.10 +opbend 53 43 0 0 14.40 +opbend 54 43 0 0 14.40 +opbend 63 43 0 0 133.10 +opbend 69 43 0 0 133.10 +opbend 72 43 0 0 0.00 +opbend 43 44 0 0 14.40 +opbend 44 44 0 0 14.40 +opbend 45 44 0 0 14.40 +opbend 47 44 0 0 14.40 +opbend 49 44 0 0 14.40 +opbend 53 44 0 0 14.40 +opbend 43 46 0 0 14.40 +opbend 45 46 0 0 14.40 +opbend 50 46 0 0 57.60 +opbend 47 48 0 0 14.40 +opbend 50 48 0 0 18.00 +opbend 44 49 0 0 14.40 +opbend 47 49 0 0 14.40 +opbend 51 49 0 0 46.80 +opbend 54 49 0 0 21.60 +opbend 58 49 0 0 14.40 +opbend 49 51 0 0 14.40 +opbend 52 51 0 0 14.40 +opbend 59 51 0 0 14.40 +opbend 43 53 0 0 14.40 +opbend 44 53 0 0 121.60 +opbend 47 53 0 0 118.70 +opbend 54 53 0 0 20.90 +opbend 55 53 0 0 86.30 +opbend 58 53 0 0 86.30 +opbend 43 54 0 0 14.40 +opbend 49 54 0 0 14.40 +opbend 53 54 0 0 14.40 +opbend 54 54 0 0 14.40 +opbend 56 54 0 0 14.40 +opbend 57 54 0 0 14.40 +opbend 60 54 0 0 14.40 +opbend 49 58 0 0 15.10 +opbend 53 58 0 0 15.10 +opbend 59 58 0 0 12.90 + + + ############################ + ## ## + ## Torsional Parameters ## + ## ## + ############################ + + +torsion 3 1 2 3 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 3 1 2 6 0.000 0.0 1 0.000 180.0 2 -0.126 0.0 3 +torsion 3 1 2 30 -0.856 0.0 1 0.048 180.0 2 -1.842 0.0 3 +torsion 4 1 2 3 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 4 1 2 6 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 4 1 2 30 0.000 0.0 1 8.000 180.0 2 0.000 0.0 3 +torsion 2 1 3 2 -1.000 0.0 1 2.000 180.0 2 2.000 0.0 3 +torsion 2 1 3 5 1.000 0.0 1 2.250 180.0 2 -2.250 0.0 3 +torsion 2 1 3 7 -1.000 0.0 1 2.000 180.0 2 2.000 0.0 3 +torsion 2 1 3 40 -1.000 0.0 1 2.000 180.0 2 2.000 0.0 3 +torsion 4 1 3 2 0.000 0.0 1 1.000 180.0 2 0.800 0.0 3 +torsion 4 1 3 5 0.000 0.0 1 1.000 180.0 2 -0.550 0.0 3 +torsion 4 1 3 7 0.000 0.0 1 1.000 180.0 2 0.800 0.0 3 +torsion 4 1 3 8 0.000 0.0 1 1.000 180.0 2 0.800 0.0 3 +torsion 4 1 3 40 0.000 0.0 1 1.000 180.0 2 0.800 0.0 3 +torsion 7 1 3 2 -1.000 0.0 1 2.000 180.0 2 2.000 0.0 3 +torsion 7 1 3 5 1.000 0.0 1 2.250 180.0 2 -2.250 0.0 3 +torsion 7 1 3 7 -1.000 0.0 1 2.000 180.0 2 2.000 0.0 3 +torsion 7 1 3 40 -1.000 0.0 1 2.000 180.0 2 2.000 0.0 3 +torsion 40 1 3 2 -1.000 0.0 1 2.000 180.0 2 2.000 0.0 3 +torsion 40 1 3 5 1.000 0.0 1 2.250 180.0 2 -2.250 0.0 3 +torsion 40 1 3 7 -1.000 0.0 1 2.000 180.0 2 2.000 0.0 3 +torsion 3 1 7 3 0.794 0.0 1 -0.639 180.0 2 0.720 0.0 3 +torsion 3 1 7 6 0.000 0.0 1 0.000 180.0 2 -0.126 0.0 3 +torsion 3 1 7 7 1.999 0.0 1 0.021 180.0 2 0.000 0.0 3 +torsion 3 1 7 8 1.999 0.0 1 0.021 180.0 2 0.000 0.0 3 +torsion 3 1 7 30 -0.856 0.0 1 0.048 180.0 2 -1.842 0.0 3 +torsion 4 1 7 3 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 4 1 7 6 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 4 1 7 7 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 4 1 7 8 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 4 1 7 30 0.000 0.0 1 8.000 180.0 2 0.000 0.0 3 +torsion 4 1 8 8 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 4 1 8 9 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 38 1 8 8 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 38 1 8 9 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 39 1 8 8 0.982 0.0 1 0.994 180.0 2 0.170 0.0 3 +torsion 39 1 8 9 0.000 0.0 1 0.000 180.0 2 -0.126 0.0 3 +torsion 3 1 40 6 0.000 0.0 1 0.000 180.0 2 -0.126 0.0 3 +torsion 4 1 40 6 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 4 1 39 1 0.000 0.0 1 4.000 180.0 2 0.000 0.0 3 +torsion 8 1 39 1 0.000 0.0 1 4.500 180.0 2 0.000 0.0 3 +torsion 38 1 39 1 0.000 0.0 1 4.000 180.0 2 0.000 0.0 3 +torsion 1 2 3 1 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 1 2 3 5 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 1 2 3 15 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 6 2 3 1 0.000 0.0 1 0.000 180.0 2 -0.010 0.0 3 +torsion 6 2 3 5 0.000 0.0 1 0.000 180.0 2 0.235 0.0 3 +torsion 6 2 3 15 0.000 0.0 1 0.000 180.0 2 -0.010 0.0 3 +torsion 41 2 3 1 -0.397 0.0 1 2.196 180.0 2 -0.371 0.0 3 +torsion 41 2 3 5 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 41 2 3 15 -0.397 0.0 1 2.196 180.0 2 -0.371 0.0 3 +torsion 1 2 30 31 -0.059 0.0 1 1.900 180.0 2 -0.045 0.0 3 +torsion 1 2 30 32 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 1 2 30 33 -0.059 0.0 1 1.900 180.0 2 -0.045 0.0 3 +torsion 6 2 30 31 -0.154 0.0 1 0.044 180.0 2 -0.086 0.0 3 +torsion 6 2 30 32 0.000 0.0 1 0.000 180.0 2 0.235 0.0 3 +torsion 6 2 30 33 -0.154 0.0 1 0.044 180.0 2 -0.086 0.0 3 +torsion 3 2 41 42 1.239 0.0 1 -0.405 180.0 2 0.035 0.0 3 +torsion 6 2 41 42 0.000 0.0 1 -0.081 180.0 2 0.370 0.0 3 +torsion 1 3 7 1 -1.688 0.0 1 4.249 180.0 2 0.000 0.0 3 +torsion 1 3 7 6 0.000 0.0 1 0.000 180.0 2 -0.010 0.0 3 +torsion 1 3 7 7 0.447 0.0 1 1.707 180.0 2 -1.342 0.0 3 +torsion 1 3 7 8 0.447 0.0 1 1.707 180.0 2 -1.342 0.0 3 +torsion 1 3 7 15 -2.118 0.0 1 1.173 180.0 2 0.000 0.0 3 +torsion 1 3 7 16 2.225 0.0 1 -1.252 180.0 2 -1.067 0.0 3 +torsion 1 3 7 35 -0.397 0.0 1 2.196 180.0 2 -0.371 0.0 3 +torsion 1 3 7 41 -0.397 0.0 1 2.196 180.0 2 -0.371 0.0 3 +torsion 5 3 7 1 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 5 3 7 6 0.000 0.0 1 0.000 180.0 2 0.235 0.0 3 +torsion 5 3 7 7 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 5 3 7 8 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 5 3 7 15 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 5 3 7 16 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 5 3 7 35 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 5 3 7 41 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 15 3 7 1 -1.804 0.0 1 3.612 180.0 2 -0.196 0.0 3 +torsion 15 3 7 6 0.000 0.0 1 0.000 180.0 2 -0.010 0.0 3 +torsion 15 3 7 7 0.355 0.0 1 1.478 180.0 2 -0.896 0.0 3 +torsion 15 3 7 8 0.355 0.0 1 1.478 180.0 2 -0.896 0.0 3 +torsion 15 3 7 15 -2.118 0.0 1 1.173 180.0 2 0.000 0.0 3 +torsion 15 3 7 16 2.225 0.0 1 -1.252 180.0 2 -1.067 0.0 3 +torsion 15 3 7 41 -0.397 0.0 1 2.196 180.0 2 -0.371 0.0 3 +torsion 1 3 8 7 0.281 0.0 1 0.664 180.0 2 -0.847 0.0 3 +torsion 1 3 8 8 -0.475 0.0 1 0.775 180.0 2 0.042 0.0 3 +torsion 1 3 8 9 0.000 0.0 1 0.000 180.0 2 0.230 0.0 3 +torsion 5 3 8 7 1.091 0.0 1 0.448 180.0 2 0.596 0.0 3 +torsion 5 3 8 8 0.454 0.0 1 0.080 180.0 2 -0.310 0.0 3 +torsion 5 3 8 9 -0.154 0.0 1 0.044 180.0 2 -0.086 0.0 3 +torsion 2 3 15 7 -1.000 0.0 1 2.000 180.0 2 2.000 0.0 3 +torsion 2 3 15 16 -1.000 0.0 1 2.000 180.0 2 2.000 0.0 3 +torsion 5 3 15 7 1.000 0.0 1 2.250 180.0 2 -2.250 0.0 3 +torsion 5 3 15 16 1.000 0.0 1 2.250 180.0 2 -2.250 0.0 3 +torsion 7 3 15 7 -1.000 0.0 1 2.000 180.0 2 2.000 0.0 3 +torsion 7 3 15 16 -1.000 0.0 1 2.000 180.0 2 2.000 0.0 3 +torsion 40 3 15 7 -1.000 0.0 1 2.000 180.0 2 2.000 0.0 3 +torsion 40 3 15 16 -1.000 0.0 1 2.000 180.0 2 2.000 0.0 3 +torsion 1 3 40 6 0.000 0.0 1 0.000 180.0 2 -0.010 0.0 3 +torsion 5 3 40 6 0.000 0.0 1 0.000 180.0 2 0.235 0.0 3 +torsion 15 3 40 6 0.000 0.0 1 0.000 180.0 2 -0.010 0.0 3 +torsion 1 7 7 6 0.000 0.0 1 0.000 180.0 2 0.500 0.0 3 +torsion 1 7 7 8 0.774 0.0 1 -1.686 180.0 2 0.000 0.0 3 +torsion 1 7 7 10 -1.094 0.0 1 0.621 180.0 2 0.018 0.0 3 +torsion 3 7 7 6 0.000 0.0 1 0.000 180.0 2 0.180 0.0 3 +torsion 3 7 7 8 1.343 0.0 1 0.135 180.0 2 0.000 0.0 3 +torsion 3 7 7 10 -0.538 0.0 1 0.703 180.0 2 -0.166 0.0 3 +torsion 6 7 7 6 0.000 0.0 1 0.000 180.0 2 0.299 0.0 3 +torsion 6 7 7 8 0.000 0.0 1 0.000 180.0 2 0.341 0.0 3 +torsion 6 7 7 10 0.000 0.0 1 0.000 180.0 2 0.341 0.0 3 +torsion 6 7 7 30 0.000 0.0 1 0.000 180.0 2 0.180 0.0 3 +torsion 6 7 7 35 0.000 0.0 1 0.000 180.0 2 0.500 0.0 3 +torsion 6 7 7 41 0.000 0.0 1 0.000 180.0 2 0.500 0.0 3 +torsion 8 7 7 30 1.343 0.0 1 0.135 180.0 2 0.000 0.0 3 +torsion 8 7 7 35 -0.282 0.0 1 -0.258 180.0 2 0.000 0.0 3 +torsion 8 7 7 41 -0.282 0.0 1 -0.258 180.0 2 0.000 0.0 3 +torsion 10 7 7 17 -0.538 0.0 1 0.703 180.0 2 -0.166 0.0 3 +torsion 10 7 7 30 -0.538 0.0 1 0.703 180.0 2 -0.166 0.0 3 +torsion 10 7 7 35 -1.094 0.0 1 0.621 180.0 2 0.018 0.0 3 +torsion 10 7 7 41 -1.094 0.0 1 0.621 180.0 2 0.018 0.0 3 +torsion 1 7 8 3 -0.508 0.0 1 -0.213 180.0 2 -0.337 0.0 3 +torsion 1 7 8 7 -0.899 0.0 1 1.078 180.0 2 -0.341 0.0 3 +torsion 1 7 8 8 0.370 0.0 1 0.594 180.0 2 -0.226 0.0 3 +torsion 1 7 8 9 0.000 0.0 1 0.000 180.0 2 0.500 0.0 3 +torsion 1 7 8 10 0.192 0.0 1 -0.115 180.0 2 -0.309 0.0 3 +torsion 1 7 8 12 -0.870 0.0 1 0.910 180.0 2 -0.718 0.0 3 +torsion 1 7 8 17 -2.284 0.0 1 1.340 180.0 2 0.000 0.0 3 +torsion 1 7 8 22 -3.042 0.0 1 1.086 180.0 2 0.000 0.0 3 +torsion 1 7 8 26 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 1 7 8 30 0.165 0.0 1 1.400 180.0 2 0.000 0.0 3 +torsion 1 7 8 14 3.405 0.0 1 2.860 180.0 2 -0.401 0.0 3 +torsion 3 7 8 3 -3.063 0.0 1 -0.952 180.0 2 0.398 0.0 3 +torsion 3 7 8 7 1.148 0.0 1 -0.289 180.0 2 -0.557 0.0 3 +torsion 3 7 8 8 2.523 0.0 1 0.931 180.0 2 -0.410 0.0 3 +torsion 3 7 8 9 0.000 0.0 1 0.000 180.0 2 0.180 0.0 3 +torsion 3 7 8 10 -1.664 0.0 1 -0.531 180.0 2 0.000 0.0 3 +torsion 3 7 8 12 -2.400 0.0 1 0.550 180.0 2 0.000 0.0 3 +torsion 3 7 8 17 -3.229 0.0 1 0.588 180.0 2 0.000 0.0 3 +torsion 3 7 8 22 -1.155 0.0 1 1.249 180.0 2 0.000 0.0 3 +torsion 3 7 8 26 0.139 0.0 1 -0.814 180.0 2 0.000 0.0 3 +torsion 3 7 8 30 -1.178 0.0 1 1.055 180.0 2 0.000 0.0 3 +torsion 3 7 8 14 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 6 7 8 3 0.000 0.0 1 0.000 180.0 2 0.180 0.0 3 +torsion 6 7 8 7 0.000 0.0 1 0.000 180.0 2 0.341 0.0 3 +torsion 6 7 8 8 0.000 0.0 1 0.000 180.0 2 0.341 0.0 3 +torsion 6 7 8 9 0.000 0.0 1 0.000 180.0 2 0.299 0.0 3 +torsion 6 7 8 10 0.000 0.0 1 0.000 180.0 2 0.341 0.0 3 +torsion 6 7 8 12 0.000 0.0 1 0.000 180.0 2 0.475 0.0 3 +torsion 6 7 8 17 0.000 0.0 1 0.000 180.0 2 0.500 0.0 3 +torsion 6 7 8 22 0.000 0.0 1 0.000 180.0 2 0.341 0.0 3 +torsion 6 7 8 26 0.000 0.0 1 0.000 180.0 2 0.500 0.0 3 +torsion 6 7 8 30 0.000 0.0 1 0.000 180.0 2 0.180 0.0 3 +torsion 6 7 8 14 0.000 0.0 1 0.000 180.0 2 0.475 0.0 3 +torsion 7 7 8 8 0.856 0.0 1 0.841 180.0 2 -0.374 0.0 3 +torsion 7 7 8 9 0.000 0.0 1 0.000 180.0 2 0.091 0.0 3 +torsion 8 7 8 7 -0.631 0.0 1 1.067 180.0 2 -0.703 0.0 3 +torsion 8 7 8 8 -0.631 0.0 1 1.067 180.0 2 -0.703 0.0 3 +torsion 8 7 8 9 0.000 0.0 1 0.000 180.0 2 0.341 0.0 3 +torsion 10 7 8 9 0.000 0.0 1 0.000 180.0 2 0.341 0.0 3 +torsion 30 7 8 3 -2.457 0.0 1 0.853 180.0 2 -0.025 0.0 3 +torsion 30 7 8 7 -1.349 0.0 1 0.221 180.0 2 -0.157 0.0 3 +torsion 30 7 8 8 0.267 0.0 1 -0.324 180.0 2 -0.321 0.0 3 +torsion 30 7 8 9 0.000 0.0 1 0.000 180.0 2 0.180 0.0 3 +torsion 30 7 8 10 -0.538 0.0 1 0.703 180.0 2 -0.166 0.0 3 +torsion 30 7 8 12 -2.400 0.0 1 0.550 180.0 2 0.000 0.0 3 +torsion 30 7 8 17 -3.229 0.0 1 0.588 180.0 2 0.000 0.0 3 +torsion 30 7 8 22 -1.155 0.0 1 1.249 180.0 2 0.000 0.0 3 +torsion 30 7 8 26 0.139 0.0 1 -0.814 180.0 2 0.000 0.0 3 +torsion 30 7 8 30 -1.178 0.0 1 1.055 180.0 2 0.000 0.0 3 +torsion 35 7 8 7 -1.602 0.0 1 1.213 180.0 2 -0.466 0.0 3 +torsion 35 7 8 9 0.000 0.0 1 0.000 180.0 2 0.500 0.0 3 +torsion 35 7 8 10 -1.094 0.0 1 0.621 180.0 2 0.018 0.0 3 +torsion 35 7 8 12 -1.070 0.0 1 1.510 180.0 2 -0.718 0.0 3 +torsion 35 7 8 17 -2.284 0.0 1 1.340 180.0 2 0.000 0.0 3 +torsion 35 7 8 22 -3.042 0.0 1 1.086 180.0 2 0.000 0.0 3 +torsion 35 7 8 26 -1.642 0.0 1 -1.232 180.0 2 0.000 0.0 3 +torsion 35 7 8 30 0.165 0.0 1 1.400 180.0 2 0.000 0.0 3 +torsion 41 7 8 3 -0.536 0.0 1 0.869 180.0 2 -0.995 0.0 3 +torsion 41 7 8 7 -1.602 0.0 1 1.213 180.0 2 -0.466 0.0 3 +torsion 41 7 8 8 0.122 0.0 1 0.091 180.0 2 0.024 0.0 3 +torsion 41 7 8 9 0.000 0.0 1 0.000 180.0 2 0.500 0.0 3 +torsion 41 7 8 10 -1.094 0.0 1 0.621 180.0 2 0.018 0.0 3 +torsion 41 7 8 12 -1.070 0.0 1 1.510 180.0 2 -0.718 0.0 3 +torsion 41 7 8 17 -2.284 0.0 1 1.340 180.0 2 0.000 0.0 3 +torsion 41 7 8 22 -3.042 0.0 1 1.086 180.0 2 0.000 0.0 3 +torsion 41 7 8 26 -1.642 0.0 1 -1.232 180.0 2 0.000 0.0 3 +torsion 41 7 8 30 0.165 0.0 1 1.400 180.0 2 0.000 0.0 3 +torsion 6 7 10 11 0.000 0.0 1 0.000 180.0 2 0.266 0.0 3 +torsion 7 7 10 11 -1.372 0.0 1 0.232 180.0 2 0.400 0.0 3 +torsion 8 7 10 11 -1.372 0.0 1 0.232 180.0 2 0.400 0.0 3 +torsion 3 7 15 3 -0.240 0.0 1 -3.086 180.0 2 -1.829 0.0 3 +torsion 3 7 15 16 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 6 7 15 3 0.000 0.0 1 0.000 180.0 2 -0.126 0.0 3 +torsion 6 7 15 16 0.000 0.0 1 0.000 180.0 2 -0.126 0.0 3 +torsion 16 7 15 3 3.089 0.0 1 5.376 180.0 2 -1.829 0.0 3 +torsion 16 7 15 16 2.216 0.0 1 0.215 180.0 2 0.810 0.0 3 +torsion 30 7 15 3 -0.240 0.0 1 -3.086 180.0 2 -1.829 0.0 3 +torsion 30 7 15 16 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 3 7 16 9 0.000 0.0 1 0.000 180.0 2 0.180 0.0 3 +torsion 3 7 16 16 -0.928 0.0 1 1.027 180.0 2 0.000 0.0 3 +torsion 6 7 16 9 0.000 0.0 1 0.000 180.0 2 0.299 0.0 3 +torsion 6 7 16 16 0.000 0.0 1 0.000 180.0 2 0.341 0.0 3 +torsion 15 7 16 9 0.000 0.0 1 0.000 180.0 2 0.500 0.0 3 +torsion 15 7 16 16 -0.201 0.0 1 0.687 180.0 2 0.000 0.0 3 +torsion 30 7 16 9 0.000 0.0 1 0.000 180.0 2 0.180 0.0 3 +torsion 30 7 16 16 -0.928 0.0 1 1.027 180.0 2 0.000 0.0 3 +torsion 41 7 16 9 0.000 0.0 1 0.000 180.0 2 0.500 0.0 3 +torsion 41 7 16 16 -0.201 0.0 1 0.687 180.0 2 0.000 0.0 3 +torsion 1 7 30 31 -0.059 0.0 1 1.900 180.0 2 -0.045 0.0 3 +torsion 1 7 30 32 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 1 7 30 33 -0.059 0.0 1 1.900 180.0 2 -0.045 0.0 3 +torsion 6 7 30 31 -0.154 0.0 1 0.044 180.0 2 -0.086 0.0 3 +torsion 6 7 30 32 0.000 0.0 1 0.000 180.0 2 0.235 0.0 3 +torsion 6 7 30 33 -0.154 0.0 1 0.044 180.0 2 -0.086 0.0 3 +torsion 7 7 30 31 0.000 0.0 1 -0.489 180.0 2 0.000 0.0 3 +torsion 7 7 30 32 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 7 7 30 33 0.000 0.0 1 -0.489 180.0 2 0.000 0.0 3 +torsion 8 7 30 31 0.000 0.0 1 -0.489 180.0 2 0.000 0.0 3 +torsion 8 7 30 32 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 8 7 30 33 0.000 0.0 1 -0.489 180.0 2 0.000 0.0 3 +torsion 15 7 30 31 -0.059 0.0 1 1.900 180.0 2 -0.045 0.0 3 +torsion 15 7 30 32 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 15 7 30 33 -0.059 0.0 1 1.900 180.0 2 -0.045 0.0 3 +torsion 16 7 30 31 0.000 0.0 1 -0.489 180.0 2 0.000 0.0 3 +torsion 16 7 30 32 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 16 7 30 33 0.000 0.0 1 -0.489 180.0 2 0.000 0.0 3 +torsion 3 7 35 37 -0.107 0.0 1 0.512 180.0 2 0.365 0.0 3 +torsion 6 7 35 37 0.072 0.0 1 -0.012 180.0 2 0.563 0.0 3 +torsion 7 7 35 37 -0.107 0.0 1 0.512 180.0 2 0.365 0.0 3 +torsion 8 7 35 37 -0.107 0.0 1 0.512 180.0 2 0.365 0.0 3 +torsion 3 7 41 16 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 3 7 41 42 1.239 0.0 1 -0.405 180.0 2 0.035 0.0 3 +torsion 6 7 41 16 0.000 0.0 1 0.000 180.0 2 -0.126 0.0 3 +torsion 6 7 41 42 0.000 0.0 1 -0.081 180.0 2 0.370 0.0 3 +torsion 7 7 41 42 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 8 7 41 42 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 16 7 41 16 2.216 0.0 1 0.215 180.0 2 0.810 0.0 3 +torsion 16 7 41 42 -0.939 0.0 1 -0.159 180.0 2 0.246 0.0 3 +torsion 1 8 8 8 -0.535 0.0 1 -0.110 180.0 2 -0.073 0.0 3 +torsion 1 8 8 9 0.000 0.0 1 0.000 180.0 2 0.374 0.0 3 +torsion 3 8 8 7 -0.257 0.0 1 -0.220 180.0 2 0.000 0.0 3 +torsion 3 8 8 9 0.000 0.0 1 0.000 180.0 2 0.180 0.0 3 +torsion 7 8 8 8 0.152 0.0 1 -0.231 180.0 2 0.378 0.0 3 +torsion 7 8 8 9 0.000 0.0 1 0.000 180.0 2 0.341 0.0 3 +torsion 7 8 8 12 0.250 0.0 1 0.160 180.0 2 -1.805 0.0 3 +torsion 7 8 8 30 -4.257 0.0 1 -0.220 180.0 2 0.000 0.0 3 +torsion 8 8 8 8 0.152 0.0 1 -0.231 180.0 2 0.378 0.0 3 +torsion 8 8 8 9 0.000 0.0 1 0.000 180.0 2 0.341 0.0 3 +torsion 8 8 8 35 0.000 0.0 1 0.064 180.0 2 0.605 0.0 3 +torsion 9 8 8 9 0.000 0.0 1 0.000 180.0 2 0.299 0.0 3 +torsion 9 8 8 12 0.000 0.0 1 0.000 180.0 2 0.475 0.0 3 +torsion 9 8 8 30 0.000 0.0 1 0.000 180.0 2 0.180 0.0 3 +torsion 9 8 8 35 0.000 0.0 1 0.000 180.0 2 0.374 0.0 3 +torsion 7 8 10 11 1.270 0.0 1 -1.023 180.0 2 -0.727 0.0 3 +torsion 9 8 10 11 0.000 0.0 1 0.000 180.0 2 0.274 0.0 3 +torsion 7 8 12 12 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 7 8 12 13 -1.096 0.0 1 0.079 180.0 2 0.384 0.0 3 +torsion 8 8 12 8 -1.061 0.0 1 0.132 180.0 2 0.330 0.0 3 +torsion 9 8 12 8 0.000 0.0 1 0.000 180.0 2 0.660 0.0 3 +torsion 9 8 12 12 0.300 0.0 1 0.000 180.0 2 0.600 0.0 3 +torsion 9 8 12 13 0.000 0.0 1 0.000 180.0 2 0.238 0.0 3 +torsion 7 8 17 17 -0.495 0.0 1 0.720 180.0 2 -0.484 0.0 3 +torsion 9 8 17 17 0.000 0.0 1 0.000 180.0 2 -0.090 0.0 3 +torsion 7 8 22 22 0.093 0.0 1 0.153 180.0 2 0.538 0.0 3 +torsion 9 8 22 22 0.000 0.0 1 0.000 180.0 2 0.341 0.0 3 +torsion 7 8 26 24 -1.821 0.0 1 -2.437 180.0 2 2.059 0.0 3 +torsion 7 8 26 26 1.094 0.0 1 -0.160 180.0 2 0.503 0.0 3 +torsion 7 8 26 29 -0.224 0.0 1 -0.084 180.0 2 0.518 0.0 3 +torsion 9 8 26 24 0.000 0.0 1 0.000 180.0 2 0.299 0.0 3 +torsion 9 8 26 26 0.000 0.0 1 0.000 180.0 2 0.299 0.0 3 +torsion 9 8 26 29 0.000 0.0 1 0.000 180.0 2 0.299 0.0 3 +torsion 7 8 30 31 0.000 0.0 1 1.039 180.0 2 0.000 0.0 3 +torsion 7 8 30 32 -0.092 0.0 1 1.124 180.0 2 0.435 0.0 3 +torsion 7 8 30 33 0.677 0.0 1 1.020 180.0 2 0.163 0.0 3 +torsion 8 8 30 31 0.000 0.0 1 0.100 180.0 2 0.000 0.0 3 +torsion 8 8 30 32 -0.092 0.0 1 1.124 180.0 2 0.435 0.0 3 +torsion 8 8 30 33 0.677 0.0 1 1.020 180.0 2 0.163 0.0 3 +torsion 9 8 30 31 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 9 8 30 32 -0.154 0.0 1 0.044 180.0 2 -0.086 0.0 3 +torsion 9 8 30 33 0.250 0.0 1 0.850 180.0 2 0.000 0.0 3 +torsion 8 8 35 36 0.000 0.0 1 0.000 180.0 2 -0.110 0.0 3 +torsion 8 8 35 37 -0.107 0.0 1 0.512 180.0 2 0.365 0.0 3 +torsion 9 8 35 36 0.000 0.0 1 -0.081 180.0 2 0.370 0.0 3 +torsion 9 8 35 37 0.000 0.0 1 0.661 180.0 2 0.288 0.0 3 +torsion 8 12 12 8 -0.940 0.0 1 -6.900 180.0 2 0.300 0.0 3 +torsion 3 15 16 6 0.000 0.0 1 0.000 180.0 2 -0.126 0.0 3 +torsion 3 15 16 16 2.216 0.0 1 0.215 180.0 2 0.810 0.0 3 +torsion 7 15 16 6 0.000 0.0 1 0.000 180.0 2 -0.126 0.0 3 +torsion 7 15 16 16 2.216 0.0 1 0.215 180.0 2 0.810 0.0 3 +torsion 6 16 16 9 0.000 0.0 1 0.000 180.0 2 0.299 0.0 3 +torsion 6 16 16 16 0.000 0.0 1 0.000 180.0 2 0.341 0.0 3 +torsion 7 16 16 9 0.000 0.0 1 0.000 180.0 2 0.341 0.0 3 +torsion 7 16 16 16 0.152 0.0 1 -0.231 180.0 2 0.378 0.0 3 +torsion 9 16 16 9 0.000 0.0 1 0.000 180.0 2 0.299 0.0 3 +torsion 9 16 16 15 0.000 0.0 1 0.000 180.0 2 0.500 0.0 3 +torsion 9 16 16 16 0.000 0.0 1 0.000 180.0 2 0.341 0.0 3 +torsion 9 16 16 41 0.000 0.0 1 0.000 180.0 2 0.500 0.0 3 +torsion 15 16 16 16 -0.201 0.0 1 0.687 180.0 2 0.000 0.0 3 +torsion 16 16 16 41 -0.201 0.0 1 0.687 180.0 2 0.000 0.0 3 +torsion 6 16 41 7 0.000 0.0 1 0.000 180.0 2 -0.126 0.0 3 +torsion 6 16 41 42 0.000 0.0 1 -0.014 180.0 2 0.295 0.0 3 +torsion 16 16 41 7 2.216 0.0 1 0.215 180.0 2 0.810 0.0 3 +torsion 16 16 41 42 -0.939 0.0 1 -0.159 180.0 2 0.246 0.0 3 +torsion 8 17 17 17 -0.610 0.0 1 4.212 180.0 2 0.000 0.0 3 +torsion 8 17 17 18 0.000 0.0 1 4.104 180.0 2 0.000 0.0 3 +torsion 17 17 17 17 -0.670 0.0 1 4.004 180.0 2 0.000 0.0 3 +torsion 17 17 17 18 0.550 0.0 1 4.534 180.0 2 -0.550 0.0 3 +torsion 17 17 17 19 0.000 0.0 1 4.470 180.0 2 0.000 0.0 3 +torsion 17 17 17 21 0.000 0.0 1 4.470 180.0 2 0.000 0.0 3 +torsion 18 17 17 18 0.000 0.0 1 4.072 180.0 2 0.000 0.0 3 +torsion 18 17 17 19 0.000 0.0 1 4.470 180.0 2 0.000 0.0 3 +torsion 18 17 17 21 0.000 0.0 1 4.470 180.0 2 0.000 0.0 3 +torsion 17 17 19 20 0.000 0.0 1 2.081 180.0 2 0.000 0.0 3 +torsion 8 22 22 22 -0.062 0.0 1 0.197 180.0 2 0.025 0.0 3 +torsion 8 22 22 23 0.000 0.0 1 3.104 180.0 2 0.000 0.0 3 +torsion 8 22 22 24 0.000 0.0 1 4.470 180.0 2 0.000 0.0 3 +torsion 22 22 22 22 -0.670 0.0 1 4.304 180.0 2 0.000 0.0 3 +torsion 22 22 22 23 0.250 0.0 1 4.534 180.0 2 -0.550 0.0 3 +torsion 22 22 22 24 0.000 0.0 1 4.470 180.0 2 0.000 0.0 3 +torsion 23 22 22 23 0.000 0.0 1 3.072 180.0 2 0.000 0.0 3 +torsion 23 22 22 24 -3.150 0.0 1 3.000 180.0 2 0.000 0.0 3 +torsion 22 22 24 22 0.000 0.0 1 10.000 180.0 2 0.000 0.0 3 +torsion 22 22 24 25 -3.150 0.0 1 5.000 180.0 2 0.000 0.0 3 +torsion 23 22 24 22 -6.650 0.0 1 10.000 180.0 2 0.000 0.0 3 +torsion 23 22 24 25 -0.530 0.0 1 3.000 180.0 2 0.000 0.0 3 +torsion 25 24 26 8 0.000 0.0 1 4.104 180.0 2 0.000 0.0 3 +torsion 25 24 26 26 -3.150 0.0 1 3.000 180.0 2 0.000 0.0 3 +torsion 25 24 26 27 -0.530 0.0 1 3.000 180.0 2 0.000 0.0 3 +torsion 28 24 26 8 0.000 0.0 1 4.212 180.0 2 0.000 0.0 3 +torsion 28 24 26 26 0.000 0.0 1 6.000 180.0 2 0.000 0.0 3 +torsion 28 24 26 27 0.000 0.0 1 3.000 180.0 2 0.000 0.0 3 +torsion 25 24 28 24 -2.744 0.0 1 3.000 180.0 2 0.000 0.0 3 +torsion 25 24 28 27 -0.530 0.0 1 3.000 180.0 2 0.000 0.0 3 +torsion 25 24 28 29 -2.744 0.0 1 3.000 180.0 2 0.000 0.0 3 +torsion 26 24 28 24 0.000 0.0 1 8.000 180.0 2 0.000 0.0 3 +torsion 26 24 28 27 0.000 0.0 1 3.000 180.0 2 0.000 0.0 3 +torsion 26 24 28 29 0.000 0.0 1 8.000 180.0 2 0.000 0.0 3 +torsion 8 26 26 24 0.000 0.0 1 4.212 180.0 2 0.000 0.0 3 +torsion 8 26 26 27 0.000 0.0 1 4.102 180.0 2 0.000 0.0 3 +torsion 8 26 26 29 0.000 0.0 1 4.212 180.0 2 0.000 0.0 3 +torsion 24 26 26 24 0.900 0.0 1 8.000 180.0 2 0.000 0.0 3 +torsion 24 26 26 27 0.755 0.0 1 3.000 180.0 2 0.000 0.0 3 +torsion 24 26 26 29 0.900 0.0 1 8.000 180.0 2 0.000 0.0 3 +torsion 27 26 26 29 0.755 0.0 1 3.000 180.0 2 0.000 0.0 3 +torsion 8 26 29 28 0.000 0.0 1 4.212 180.0 2 0.000 0.0 3 +torsion 26 26 29 28 0.000 0.0 1 6.000 180.0 2 0.000 0.0 3 +torsion 27 26 29 28 0.000 0.0 1 3.000 180.0 2 0.000 0.0 3 +torsion 24 28 29 26 0.000 0.0 1 8.000 180.0 2 0.000 0.0 3 +torsion 27 28 29 26 0.000 0.0 1 3.000 180.0 2 0.000 0.0 3 +torsion 2 30 33 34 0.000 0.0 1 5.390 180.0 2 1.230 0.0 3 +torsion 7 30 33 34 0.000 0.0 1 5.390 180.0 2 1.230 0.0 3 +torsion 8 30 33 34 0.000 0.0 1 5.390 180.0 2 1.230 0.0 3 +torsion 32 30 33 34 -1.200 0.0 1 5.390 180.0 2 0.400 0.0 3 +torsion 46 43 44 44 0.000 0.0 1 8.761 180.0 2 0.000 0.0 3 +torsion 46 43 44 47 0.000 0.0 1 9.022 180.0 2 0.000 0.0 3 +torsion 49 43 44 44 0.000 0.0 1 8.406 180.0 2 0.000 0.0 3 +torsion 49 43 44 47 0.000 0.0 1 9.925 180.0 2 0.000 0.0 3 +torsion 63 43 44 44 0.000 0.0 1 8.406 180.0 2 0.000 0.0 3 +torsion 63 43 44 47 0.000 0.0 1 9.925 180.0 2 0.000 0.0 3 +torsion 69 43 44 44 0.000 0.0 1 8.406 180.0 2 0.000 0.0 3 +torsion 69 43 44 47 0.000 0.0 1 9.925 180.0 2 0.000 0.0 3 +torsion 44 43 46 45 0.000 0.0 1 5.807 180.0 2 0.000 0.0 3 +torsion 44 43 46 50 0.000 0.0 1 9.943 180.0 2 0.000 0.0 3 +torsion 49 43 46 45 0.000 0.0 1 0.111 180.0 2 0.000 0.0 3 +torsion 49 43 46 50 0.000 0.0 1 9.536 180.0 2 0.000 0.0 3 +torsion 63 43 46 45 0.000 0.0 1 6.111 180.0 2 0.000 0.0 3 +torsion 63 43 46 50 0.000 0.0 1 8.536 180.0 2 0.000 0.0 3 +torsion 69 43 46 45 0.000 0.0 1 9.911 180.0 2 0.000 0.0 3 +torsion 69 43 46 50 0.000 0.0 1 8.536 180.0 2 0.000 0.0 3 +torsion 44 43 49 50 0.000 0.0 1 2.100 180.0 2 0.000 0.0 3 +torsion 54 43 53 47 0.000 0.0 1 3.000 180.0 2 0.600 0.0 3 +torsion 54 43 53 55 0.000 0.0 1 -9.900 180.0 2 -0.027 0.0 3 +torsion 54 43 53 58 0.000 0.0 1 9.900 180.0 2 0.000 0.0 3 +torsion 63 43 53 47 0.000 0.0 1 0.000 180.0 2 -0.532 0.0 6 +torsion 63 43 53 55 0.000 0.0 1 0.000 180.0 2 0.112 0.0 6 +torsion 63 43 53 58 0.000 0.0 1 0.000 180.0 2 -0.532 0.0 6 +torsion 69 43 53 47 0.000 0.0 1 0.500 180.0 2 -0.532 0.0 3 +torsion 69 43 53 55 0.000 0.0 1 0.000 180.0 2 0.112 0.0 3 +torsion 69 43 53 58 0.000 0.0 1 0.000 180.0 2 -0.532 0.0 6 +torsion 53 43 54 54 0.000 0.0 1 4.500 180.0 2 0.000 0.0 3 +torsion 53 43 54 57 0.000 0.0 1 2.000 180.0 2 0.000 0.0 3 +torsion 63 43 54 54 0.000 0.0 1 0.000 180.0 2 -0.532 0.0 6 +torsion 63 43 54 57 0.000 0.0 1 0.000 180.0 2 0.109 0.0 6 +torsion 69 43 54 54 0.000 0.0 1 0.000 180.0 2 -0.532 0.0 6 +torsion 69 43 54 57 0.000 0.0 1 0.000 180.0 2 0.109 0.0 6 +torsion 44 43 63 62 -3.000 0.0 1 0.000 180.0 2 -0.900 0.0 3 +torsion 44 43 63 63 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 44 43 63 65 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 44 43 63 68 0.000 0.0 1 -5.600 180.0 2 0.000 0.0 3 +torsion 46 43 63 62 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 46 43 63 63 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 46 43 63 65 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 46 43 63 68 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 53 43 63 62 -3.000 0.0 1 0.000 180.0 2 0.950 0.0 3 +torsion 53 43 63 63 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 53 43 63 65 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 54 43 63 62 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 54 43 63 63 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 54 43 63 65 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 72 43 63 62 0.000 0.0 1 0.000 180.0 2 0.587 0.0 3 +torsion 72 43 63 63 0.000 0.0 1 0.000 180.0 2 0.585 0.0 3 +torsion 72 43 63 65 0.000 0.0 1 4.500 180.0 2 0.480 0.0 3 +torsion 44 43 69 62 0.000 0.0 1 -7.550 180.0 2 0.880 0.0 3 +torsion 44 43 69 65 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 44 43 69 68 0.000 0.0 1 -5.200 180.0 2 0.800 0.0 3 +torsion 44 43 69 69 0.000 0.0 1 2.000 180.0 2 0.800 0.0 3 +torsion 46 43 69 62 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 46 43 69 65 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 46 43 69 68 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 46 43 69 69 0.000 0.0 1 -5.100 180.0 2 0.800 0.0 3 +torsion 53 43 69 62 0.000 0.0 1 -1.600 180.0 2 0.000 0.0 3 +torsion 53 43 69 65 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 53 43 69 69 0.000 0.0 1 -1.500 180.0 2 0.000 0.0 3 +torsion 54 43 69 62 0.000 0.0 1 -5.600 180.0 2 -0.650 0.0 3 +torsion 54 43 69 65 0.000 0.0 1 0.000 180.0 2 0.000 0.0 3 +torsion 54 43 69 69 0.000 0.0 1 -2.000 180.0 2 0.000 0.0 3 +torsion 72 43 69 62 0.000 0.0 1 0.000 180.0 2 0.587 0.0 3 +torsion 72 43 69 65 0.000 0.0 1 4.500 180.0 2 0.480 0.0 3 +torsion 72 43 69 69 0.000 0.0 1 2.500 180.0 2 0.585 0.0 3 +torsion 43 44 44 45 0.000 0.0 1 7.121 180.0 2 0.000 0.0 3 +torsion 43 44 44 49 0.000 0.0 1 8.267 180.0 2 0.000 0.0 3 +torsion 43 44 44 53 0.000 0.0 1 8.538 180.0 2 0.000 0.0 3 +torsion 45 44 44 47 0.000 0.0 1 5.794 180.0 2 0.000 0.0 3 +torsion 47 44 44 49 0.000 0.0 1 9.772 180.0 2 0.000 0.0 3 +torsion 47 44 44 53 0.000 0.0 1 4.676 180.0 2 0.000 0.0 3 +torsion 44 44 45 46 0.000 0.0 1 9.600 180.0 2 0.000 0.0 3 +torsion 49 44 45 46 0.000 0.0 1 8.083 180.0 2 0.000 0.0 3 +torsion 53 44 45 46 0.000 0.0 1 6.522 180.0 2 0.000 0.0 3 +torsion 43 44 47 48 0.000 0.0 1 8.058 180.0 2 0.000 0.0 3 +torsion 43 44 47 49 0.000 0.0 1 5.000 180.0 2 0.000 0.0 3 +torsion 44 44 47 48 0.000 0.0 1 8.174 180.0 2 0.000 0.0 3 +torsion 44 44 47 49 0.000 0.0 1 3.500 180.0 2 0.000 0.0 3 +torsion 44 44 49 47 0.000 0.0 1 8.034 180.0 2 0.000 0.0 3 +torsion 44 44 49 51 0.000 0.0 1 8.960 180.0 2 0.000 0.0 3 +torsion 45 44 49 47 0.000 0.0 1 8.118 180.0 2 0.000 0.0 3 +torsion 45 44 49 51 0.000 0.0 1 6.606 180.0 2 0.000 0.0 3 +torsion 44 44 53 55 0.000 0.0 1 9.293 180.0 2 0.000 0.0 3 +torsion 44 44 53 58 0.000 0.0 1 1.587 180.0 2 0.000 0.0 3 +torsion 45 44 53 55 0.000 0.0 1 1.522 180.0 2 0.000 0.0 3 +torsion 45 44 53 58 0.000 0.0 1 8.876 180.0 2 0.000 0.0 3 +torsion 44 45 46 43 0.000 0.0 1 9.800 180.0 2 0.000 0.0 3 +torsion 44 45 46 50 0.000 0.0 1 7.386 180.0 2 0.000 0.0 3 +torsion 44 47 48 47 0.000 0.0 1 8.468 180.0 2 0.000 0.0 3 +torsion 44 47 48 50 0.000 0.0 1 8.900 180.0 2 0.000 0.0 3 +torsion 49 47 48 47 0.000 0.0 1 9.883 180.0 2 0.000 0.0 3 +torsion 49 47 48 50 0.000 0.0 1 10.000 180.0 2 0.000 0.0 3 +torsion 44 47 49 51 0.000 0.0 1 2.000 180.0 2 0.000 0.0 3 +torsion 44 47 49 58 0.000 0.0 1 2.000 180.0 2 0.000 0.0 3 +torsion 48 47 49 44 0.000 0.0 1 9.804 180.0 2 0.000 0.0 3 +torsion 48 47 49 51 0.000 0.0 1 1.928 180.0 2 0.000 0.0 3 +torsion 53 47 49 51 0.000 0.0 1 2.000 180.0 2 0.000 0.0 3 +torsion 53 47 49 54 0.000 0.0 1 2.000 180.0 2 0.000 0.0 3 +torsion 49 47 53 43 0.000 0.0 1 2.000 180.0 2 0.000 0.0 3 +torsion 49 47 53 55 0.000 0.0 1 2.000 180.0 2 0.000 0.0 3 +torsion 44 49 51 52 0.000 0.0 1 2.000 180.0 2 0.000 0.0 3 +torsion 44 49 51 59 0.000 0.0 1 2.000 180.0 2 0.000 0.0 3 +torsion 47 49 51 52 0.000 0.0 1 2.000 180.0 2 0.000 0.0 3 +torsion 47 49 51 59 0.000 0.0 1 2.000 180.0 2 0.000 0.0 3 +torsion 54 49 51 52 0.000 0.0 1 2.000 180.0 2 0.000 0.0 3 +torsion 54 49 51 59 0.000 0.0 1 2.000 180.0 2 0.000 0.0 3 +torsion 58 49 51 52 0.000 0.0 1 5.000 180.0 2 0.000 0.0 3 +torsion 58 49 51 59 0.000 0.0 1 5.000 180.0 2 0.000 0.0 3 +torsion 47 49 54 54 0.000 0.0 1 9.974 180.0 2 0.000 0.0 3 +torsion 47 49 54 56 0.000 0.0 1 9.548 180.0 2 0.000 0.0 3 +torsion 51 49 54 54 0.000 0.0 1 5.322 180.0 2 0.000 0.0 3 +torsion 51 49 54 56 0.000 0.0 1 4.112 180.0 2 0.000 0.0 3 +torsion 47 49 58 53 0.000 0.0 1 2.000 180.0 2 0.000 0.0 3 +torsion 47 49 58 59 0.000 0.0 1 2.000 180.0 2 0.000 0.0 3 +torsion 51 49 58 53 0.000 0.0 1 2.000 180.0 2 0.000 0.0 3 +torsion 51 49 58 59 0.000 0.0 1 2.000 180.0 2 0.000 0.0 3 +torsion 55 53 54 54 0.000 0.0 1 2.654 180.0 2 0.000 0.0 3 +torsion 55 53 54 56 0.000 0.0 1 3.756 180.0 2 0.000 0.0 3 +torsion 55 53 54 60 0.000 0.0 1 4.085 180.0 2 0.000 0.0 3 +torsion 58 53 54 54 0.000 0.0 1 5.537 180.0 2 0.000 0.0 3 +torsion 58 53 54 56 0.000 0.0 1 6.277 180.0 2 0.000 0.0 3 +torsion 58 53 54 60 0.000 0.0 1 2.346 180.0 2 0.000 0.0 3 +torsion 43 53 58 53 0.000 0.0 1 2.500 180.0 2 0.000 0.0 3 +torsion 43 53 58 59 0.000 0.0 1 3.300 180.0 2 0.000 0.0 3 +torsion 44 53 58 49 0.000 0.0 1 2.000 180.0 2 0.000 0.0 3 +torsion 44 53 58 59 0.000 0.0 1 2.000 180.0 2 0.000 0.0 3 +torsion 54 53 58 53 0.000 0.0 1 1.000 180.0 2 0.000 0.0 3 +torsion 54 53 58 59 0.000 0.0 1 2.500 180.0 2 0.000 0.0 3 +torsion 55 53 58 49 0.000 0.0 1 8.000 180.0 2 0.000 0.0 3 +torsion 55 53 58 53 0.000 0.0 1 3.100 180.0 2 0.000 0.0 3 +torsion 55 53 58 59 0.000 0.0 1 1.155 180.0 2 0.000 0.0 3 +torsion 43 54 54 49 0.000 0.0 1 7.934 180.0 2 0.000 0.0 3 +torsion 43 54 54 53 0.000 0.0 1 -9.000 180.0 2 0.000 0.0 3 +torsion 43 54 54 56 0.000 0.0 1 1.094 180.0 2 0.000 0.0 3 +torsion 43 54 54 60 0.000 0.0 1 5.133 180.0 2 0.000 0.0 3 +torsion 49 54 54 57 0.000 0.0 1 7.193 180.0 2 0.000 0.0 3 +torsion 53 54 54 57 0.000 0.0 1 6.193 180.0 2 0.000 0.0 3 +torsion 56 54 54 57 0.000 0.0 1 4.226 180.0 2 0.000 0.0 3 +torsion 57 54 54 60 0.000 0.0 1 6.519 180.0 2 0.000 0.0 3 +torsion 53 54 60 61 0.000 0.0 1 0.000 180.0 2 0.319 0.0 3 +torsion 54 54 60 61 0.000 0.0 1 0.000 180.0 2 -0.091 0.0 3 +torsion 61 60 62 70 0.000 0.0 1 0.000 180.0 2 -0.070 0.0 3 +torsion 61 60 62 72 0.000 0.0 1 0.000 180.0 2 0.169 0.0 3 +torsion 63 60 62 70 0.000 0.0 1 -2.500 180.0 2 -0.603 0.0 3 +torsion 63 60 62 72 0.000 0.0 1 -0.580 180.0 2 0.980 0.0 3 +torsion 69 60 62 70 0.000 0.0 1 -2.500 180.0 2 -0.603 0.0 3 +torsion 69 60 62 72 0.000 0.0 1 -0.580 180.0 2 0.980 0.0 3 +torsion 61 60 63 62 0.000 0.0 1 0.000 180.0 2 0.380 0.0 3 +torsion 61 60 63 63 0.000 0.0 1 0.000 180.0 2 0.380 0.0 3 +torsion 61 60 63 64 0.000 0.0 1 0.000 180.0 2 0.380 0.0 3 +torsion 61 60 63 68 0.000 0.0 1 0.000 180.0 2 0.380 0.0 3 +torsion 62 60 63 62 0.000 0.0 1 -3.500 180.0 2 0.380 0.0 3 +torsion 62 60 63 63 0.000 0.0 1 3.500 180.0 2 -0.370 0.0 3 +torsion 62 60 63 64 0.000 0.0 1 0.000 180.0 2 0.382 0.0 3 +torsion 62 60 63 68 0.000 0.0 1 -3.500 180.0 2 0.380 0.0 3 +torsion 61 60 69 62 0.000 0.0 1 0.000 180.0 2 0.480 0.0 3 +torsion 61 60 69 64 0.000 0.0 1 0.000 180.0 2 0.480 0.0 3 +torsion 61 60 69 68 0.000 0.0 1 0.000 180.0 2 0.480 0.0 3 +torsion 61 60 69 69 0.000 0.0 1 0.000 180.0 2 0.480 0.0 3 +torsion 62 60 69 62 0.000 0.0 1 -1.500 180.0 2 0.280 0.0 3 +torsion 62 60 69 64 0.000 0.0 1 0.000 180.0 2 0.280 0.0 3 +torsion 62 60 69 68 0.000 0.0 1 -1.500 180.0 2 0.280 0.0 3 +torsion 62 60 69 69 0.000 0.0 1 3.000 180.0 2 -0.370 0.0 3 +torsion 63 62 63 43 0.000 0.0 1 0.000 180.0 2 0.286 0.0 3 +torsion 63 62 63 60 0.000 0.0 1 0.000 180.0 2 0.286 0.0 3 +torsion 63 62 63 63 0.000 0.0 1 0.000 180.0 2 0.786 0.0 3 +torsion 63 62 63 64 0.000 0.0 1 0.000 180.0 2 0.286 0.0 3 +torsion 63 62 63 65 0.000 0.0 1 0.000 180.0 2 0.286 0.0 3 +torsion 70 62 63 63 0.000 0.0 1 0.000 180.0 2 0.886 0.0 3 +torsion 70 62 63 64 0.000 0.0 1 0.000 180.0 2 -0.070 0.0 3 +torsion 72 62 63 63 -1.500 0.0 1 2.000 180.0 2 0.186 0.0 3 +torsion 72 62 63 64 0.000 0.0 1 0.000 180.0 2 0.686 0.0 3 +torsion 69 62 69 43 0.000 0.0 1 0.000 180.0 2 0.286 0.0 3 +torsion 69 62 69 60 0.000 0.0 1 0.000 180.0 2 0.286 0.0 3 +torsion 69 62 69 64 0.000 0.0 1 0.000 180.0 2 0.286 0.0 3 +torsion 69 62 69 65 0.000 0.0 1 0.000 180.0 2 0.386 0.0 3 +torsion 69 62 69 69 2.000 0.0 1 -1.500 180.0 2 0.886 0.0 3 +torsion 70 62 69 64 0.000 0.0 1 0.000 180.0 2 -0.070 0.0 3 +torsion 70 62 69 69 0.000 0.0 1 0.000 180.0 2 0.886 0.0 3 +torsion 72 62 69 64 0.000 0.0 1 0.000 180.0 2 0.686 0.0 3 +torsion 72 62 69 69 -1.500 0.0 1 2.000 180.0 2 0.186 0.0 3 +torsion 60 62 70 62 -2.000 0.0 1 -1.680 180.0 2 -0.800 0.0 3 +torsion 60 62 70 71 0.000 0.0 1 0.000 180.0 2 0.990 0.0 3 +torsion 63 62 70 62 -2.000 0.0 1 -1.680 180.0 2 -0.800 0.0 3 +torsion 63 62 70 71 0.000 0.0 1 0.000 180.0 2 0.990 0.0 3 +torsion 69 62 70 62 -2.000 0.0 1 -1.680 180.0 2 -0.800 0.0 3 +torsion 69 62 70 71 0.000 0.0 1 0.000 180.0 2 0.990 0.0 3 +torsion 43 63 63 63 0.000 0.0 1 0.000 180.0 2 0.386 0.0 3 +torsion 43 63 63 64 0.000 0.0 1 0.000 180.0 2 0.286 0.0 3 +torsion 43 63 63 66 0.000 0.0 1 0.000 180.0 2 0.386 0.0 3 +torsion 60 63 63 62 0.000 0.0 1 0.500 180.0 2 0.486 0.0 3 +torsion 60 63 63 63 0.000 0.0 1 0.000 180.0 2 -0.286 0.0 3 +torsion 60 63 63 64 0.000 0.0 1 0.000 180.0 2 0.286 0.0 3 +torsion 62 63 63 62 0.000 0.0 1 0.000 180.0 2 0.286 0.0 3 +torsion 62 63 63 63 0.000 0.0 1 0.000 180.0 2 0.386 0.0 3 +torsion 62 63 63 64 0.000 0.0 1 0.000 180.0 2 0.286 0.0 3 +torsion 62 63 63 66 0.000 0.0 1 0.000 180.0 2 0.386 0.0 3 +torsion 62 63 63 68 0.000 0.0 1 0.000 180.0 2 0.286 0.0 3 +torsion 63 63 63 63 0.000 0.0 1 0.000 180.0 2 0.386 0.0 3 +torsion 63 63 63 64 0.000 0.0 1 0.000 180.0 2 0.286 0.0 3 +torsion 63 63 63 65 0.000 0.0 1 0.000 180.0 2 0.386 0.0 3 +torsion 63 63 63 66 0.000 0.0 1 0.000 180.0 2 0.386 0.0 3 +torsion 63 63 63 68 0.000 0.0 1 0.000 180.0 2 0.386 0.0 3 +torsion 64 63 63 64 0.000 0.0 1 0.000 180.0 2 0.286 0.0 3 +torsion 64 63 63 65 0.000 0.0 1 0.000 180.0 2 0.186 0.0 3 +torsion 64 63 63 66 0.000 0.0 1 0.000 180.0 2 0.386 0.0 3 +torsion 64 63 63 68 0.000 0.0 1 0.000 180.0 2 0.286 0.0 3 +torsion 65 63 63 66 0.000 0.0 1 0.000 180.0 2 0.386 0.0 3 +torsion 66 63 63 68 0.000 0.0 1 0.000 180.0 2 0.386 0.0 3 +torsion 63 63 66 67 -3.500 0.0 1 1.000 180.0 2 0.186 0.0 3 +torsion 64 63 66 67 0.000 0.0 1 0.000 180.0 2 0.186 0.0 3 +torsion 43 63 68 63 0.000 0.0 1 0.000 180.0 2 0.286 0.0 3 +torsion 60 63 68 63 0.000 0.0 1 0.000 180.0 2 0.286 0.0 3 +torsion 63 63 68 63 0.000 0.0 1 0.000 180.0 2 0.886 0.0 3 +torsion 64 63 68 63 0.000 0.0 1 0.000 180.0 2 0.286 0.0 3 +torsion 65 63 68 63 0.000 0.0 1 0.000 180.0 2 0.286 0.0 3 +torsion 69 68 69 43 0.000 0.0 1 0.000 180.0 2 0.086 0.0 3 +torsion 69 68 69 60 0.000 0.0 1 0.000 180.0 2 0.286 0.0 3 +torsion 69 68 69 64 0.000 0.0 1 0.000 180.0 2 0.286 0.0 3 +torsion 69 68 69 65 0.000 0.0 1 0.000 180.0 2 0.386 0.0 3 +torsion 69 68 69 69 3.000 0.0 1 -3.000 180.0 2 -0.886 0.0 3 +torsion 43 69 69 64 0.000 0.0 1 0.000 180.0 2 0.186 0.0 3 +torsion 43 69 69 69 0.000 0.0 1 0.000 180.0 2 0.186 0.0 3 +torsion 60 69 69 62 0.000 0.0 1 0.000 180.0 2 0.186 0.0 3 +torsion 60 69 69 64 0.000 0.0 1 0.000 180.0 2 0.186 0.0 3 +torsion 60 69 69 69 0.000 0.0 1 0.000 180.0 2 0.886 0.0 3 +torsion 62 69 69 62 0.000 0.0 1 0.000 180.0 2 0.186 0.0 3 +torsion 62 69 69 64 0.000 0.0 1 0.000 180.0 2 0.186 0.0 3 +torsion 62 69 69 68 0.000 0.0 1 0.000 180.0 2 0.186 0.0 3 +torsion 62 69 69 69 0.000 0.0 1 0.000 180.0 2 0.886 0.0 3 +torsion 64 69 69 64 0.000 0.0 1 0.000 180.0 2 0.186 0.0 3 +torsion 64 69 69 65 0.000 0.0 1 0.000 180.0 2 0.186 0.0 3 +torsion 64 69 69 68 0.000 0.0 1 0.000 180.0 2 0.186 0.0 3 +torsion 64 69 69 69 0.000 0.0 1 0.000 180.0 2 0.186 0.0 3 +torsion 65 69 69 69 0.000 0.0 1 0.000 180.0 2 0.186 0.0 3 +torsion 68 69 69 69 0.000 0.0 1 0.000 180.0 2 0.186 0.0 3 +torsion 69 69 69 69 0.000 0.0 1 0.000 180.0 2 0.886 0.0 3 + + + ############################# + ## ## + ## Pi-Torsion Parameters ## + ## ## + ############################# + + +pitors 1 3 6.85 +pitors 3 15 6.85 +pitors 17 17 6.85 +pitors 22 22 6.85 +pitors 22 24 6.85 +pitors 24 26 6.85 +pitors 24 28 6.85 +pitors 26 26 6.85 +pitors 43 44 5.85 +pitors 43 46 5.85 +pitors 43 53 5.85 +pitors 43 54 5.85 +pitors 44 44 5.85 +pitors 44 45 5.85 +pitors 44 47 5.85 +pitors 44 49 5.85 +pitors 44 53 5.85 +pitors 45 46 5.85 +pitors 47 48 5.85 +pitors 47 49 5.85 +pitors 47 53 5.85 +pitors 49 54 5.85 +pitors 49 58 9.85 +pitors 53 54 5.85 +pitors 53 58 5.85 +pitors 54 54 7.85 + + + ################################## + ## ## + ## Torsion-Torsion Parameters ## + ## ## + ################################## + + +tortors 3 1 2 3 1 25 25 + -180.0 -180.0 0.00000 + -165.0 -180.0 -0.15918 + -150.0 -180.0 -0.46924 + -135.0 -180.0 -0.94887 + -120.0 -180.0 -1.41919 + -105.0 -180.0 -1.89608 + -90.0 -180.0 -2.35024 + -75.0 -180.0 -2.81648 + -60.0 -180.0 -3.17758 + -45.0 -180.0 -2.91092 + -30.0 -180.0 -1.84916 + -15.0 -180.0 -0.61868 + 0.0 -180.0 1.44957 + 15.0 -180.0 -0.61868 + 30.0 -180.0 -1.84916 + 45.0 -180.0 -2.91092 + 60.0 -180.0 -3.17758 + 75.0 -180.0 -2.81793 + 90.0 -180.0 -2.34954 + 105.0 -180.0 -1.91578 + 120.0 -180.0 -1.41919 + 135.0 -180.0 -0.94887 + 150.0 -180.0 -0.46924 + 165.0 -180.0 -0.15918 + 180.0 -180.0 0.00000 + -180.0 -165.0 -0.03043 + -165.0 -165.0 -0.40282 + -150.0 -165.0 -0.84288 + -135.0 -165.0 -1.22723 + -120.0 -165.0 -1.58634 + -105.0 -165.0 -1.98317 + -90.0 -165.0 -2.46682 + -75.0 -165.0 -2.96238 + -60.0 -165.0 -3.27921 + -45.0 -165.0 -2.85897 + -30.0 -165.0 -1.66034 + -15.0 -165.0 0.28654 + 0.0 -165.0 0.47583 + 15.0 -165.0 -0.59328 + 30.0 -165.0 -1.85441 + 45.0 -165.0 -2.72832 + 60.0 -165.0 -2.82977 + 75.0 -165.0 -2.43750 + 90.0 -165.0 -1.97978 + 105.0 -165.0 -1.47132 + 120.0 -165.0 -0.94989 + 135.0 -165.0 -0.44166 + 150.0 -165.0 -0.04055 + 165.0 -165.0 0.10146 + 180.0 -165.0 -0.03043 + -180.0 -150.0 -0.05487 + -165.0 -150.0 -0.49639 + -150.0 -150.0 -0.83418 + -135.0 -150.0 -1.02443 + -120.0 -150.0 -1.24614 + -105.0 -150.0 -1.65671 + -90.0 -150.0 -2.17397 + -75.0 -150.0 -2.73078 + -60.0 -150.0 -2.95919 + -45.0 -150.0 -2.36553 + -30.0 -150.0 -0.65594 + -15.0 -150.0 1.60921 + 0.0 -150.0 0.68197 + 15.0 -150.0 -0.47503 + 30.0 -150.0 -1.60792 + 45.0 -150.0 -2.28172 + 60.0 -150.0 -2.27657 + 75.0 -150.0 -1.84368 + 90.0 -150.0 -1.32072 + 105.0 -150.0 -0.79693 + 120.0 -150.0 -0.27502 + 135.0 -150.0 0.15792 + 150.0 -150.0 0.37394 + 165.0 -150.0 0.30007 + 180.0 -150.0 -0.05487 + -180.0 -135.0 0.22137 + -165.0 -135.0 -0.11507 + -150.0 -135.0 -0.25069 + -135.0 -135.0 -0.25120 + -120.0 -135.0 -0.45372 + -105.0 -135.0 -0.91494 + -90.0 -135.0 -1.48283 + -75.0 -135.0 -1.97985 + -60.0 -135.0 -1.99291 + -45.0 -135.0 -0.87317 + -30.0 -135.0 2.15102 + -15.0 -135.0 2.08125 + 0.0 -135.0 1.01469 + 15.0 -135.0 -0.13409 + 30.0 -135.0 -1.08446 + 45.0 -135.0 -1.57764 + 60.0 -135.0 -1.54005 + 75.0 -135.0 -1.11846 + 90.0 -135.0 -0.54882 + 105.0 -135.0 -0.14353 + 120.0 -135.0 0.35059 + 135.0 -135.0 0.78961 + 150.0 -135.0 0.82176 + 165.0 -135.0 0.59900 + 180.0 -135.0 0.22137 + -180.0 -120.0 0.76282 + -165.0 -120.0 0.65049 + -150.0 -120.0 0.73226 + -135.0 -120.0 0.80302 + -120.0 -120.0 0.46767 + -105.0 -120.0 -0.17578 + -90.0 -120.0 -0.55868 + -75.0 -120.0 -0.87022 + -60.0 -120.0 -0.44624 + -45.0 -120.0 1.42775 + -30.0 -120.0 3.49117 + -15.0 -120.0 2.47433 + 0.0 -120.0 1.40660 + 15.0 -120.0 0.51132 + 30.0 -120.0 -0.07964 + 45.0 -120.0 -0.49787 + 60.0 -120.0 -0.64487 + 75.0 -120.0 -0.35755 + 90.0 -120.0 0.18803 + 105.0 -120.0 0.54550 + 120.0 -120.0 0.97289 + 135.0 -120.0 1.16949 + 150.0 -120.0 1.15910 + 165.0 -120.0 1.05012 + 180.0 -120.0 0.76282 + -180.0 -105.0 1.42827 + -165.0 -105.0 1.50406 + -150.0 -105.0 1.72284 + -135.0 -105.0 1.64917 + -120.0 -105.0 1.03764 + -105.0 -105.0 0.56475 + -90.0 -105.0 0.20084 + -75.0 -105.0 0.20821 + -60.0 -105.0 1.22814 + -45.0 -105.0 2.98189 + -30.0 -105.0 3.57647 + -15.0 -105.0 2.65211 + 0.0 -105.0 1.95317 + 15.0 -105.0 1.65224 + 30.0 -105.0 1.43567 + 45.0 -105.0 0.92486 + 60.0 -105.0 0.55065 + 75.0 -105.0 0.46027 + 90.0 -105.0 0.60470 + 105.0 -105.0 1.02077 + 120.0 -105.0 1.33189 + 135.0 -105.0 1.51499 + 150.0 -105.0 1.50886 + 165.0 -105.0 1.53133 + 180.0 -105.0 1.42827 + -180.0 -90.0 1.90401 + -165.0 -90.0 2.03939 + -150.0 -90.0 2.29924 + -135.0 -90.0 1.79055 + -120.0 -90.0 1.35280 + -105.0 -90.0 1.02391 + -90.0 -90.0 0.90562 + -75.0 -90.0 1.23397 + -60.0 -90.0 2.45075 + -45.0 -90.0 3.45522 + -30.0 -90.0 3.09983 + -15.0 -90.0 2.62493 + 0.0 -90.0 2.65047 + 15.0 -90.0 3.09474 + 30.0 -90.0 2.79428 + 45.0 -90.0 2.15793 + 60.0 -90.0 1.57482 + 75.0 -90.0 1.33310 + 90.0 -90.0 1.13012 + 105.0 -90.0 1.17449 + 120.0 -90.0 1.41199 + 135.0 -90.0 1.62671 + 150.0 -90.0 1.81755 + 165.0 -90.0 1.82118 + 180.0 -90.0 1.90401 + -180.0 -75.0 1.80621 + -165.0 -75.0 2.08080 + -150.0 -75.0 2.03556 + -135.0 -75.0 1.68691 + -120.0 -75.0 1.29208 + -105.0 -75.0 1.22509 + -90.0 -75.0 1.43311 + -75.0 -75.0 2.16375 + -60.0 -75.0 2.17320 + -45.0 -75.0 2.21268 + -30.0 -75.0 2.13049 + -15.0 -75.0 2.40205 + 0.0 -75.0 3.24329 + 15.0 -75.0 4.06613 + 30.0 -75.0 3.57523 + 45.0 -75.0 2.86443 + 60.0 -75.0 2.31976 + 75.0 -75.0 1.66472 + 90.0 -75.0 1.27852 + 105.0 -75.0 1.09103 + 120.0 -75.0 1.36656 + 135.0 -75.0 1.53314 + 150.0 -75.0 1.59747 + 165.0 -75.0 1.64225 + 180.0 -75.0 1.80621 + -180.0 -60.0 0.94133 + -165.0 -60.0 1.07716 + -150.0 -60.0 1.06365 + -135.0 -60.0 0.96211 + -120.0 -60.0 0.94411 + -105.0 -60.0 1.25994 + -90.0 -60.0 0.79628 + -75.0 -60.0 0.57562 + -60.0 -60.0 0.56577 + -45.0 -60.0 0.74572 + -30.0 -60.0 1.24745 + -15.0 -60.0 2.21612 + 0.0 -60.0 3.54214 + 15.0 -60.0 3.78367 + 30.0 -60.0 3.40120 + 45.0 -60.0 2.89718 + 60.0 -60.0 1.94715 + 75.0 -60.0 1.36042 + 90.0 -60.0 0.79250 + 105.0 -60.0 0.57769 + 120.0 -60.0 0.77935 + 135.0 -60.0 0.79351 + 150.0 -60.0 0.75367 + 165.0 -60.0 0.78581 + 180.0 -60.0 0.94133 + -180.0 -45.0 -0.67275 + -165.0 -45.0 -0.59212 + -150.0 -45.0 -0.42200 + -135.0 -45.0 -0.01106 + -120.0 -45.0 -0.51470 + -105.0 -45.0 -0.80922 + -90.0 -45.0 -0.99538 + -75.0 -45.0 -1.06430 + -60.0 -45.0 -0.87844 + -45.0 -45.0 -0.24576 + -30.0 -45.0 0.77634 + -15.0 -45.0 2.05251 + 0.0 -45.0 2.78505 + 15.0 -45.0 3.13379 + 30.0 -45.0 2.85045 + 45.0 -45.0 2.19151 + 60.0 -45.0 1.16243 + 75.0 -45.0 0.20720 + 90.0 -45.0 -0.42237 + 105.0 -45.0 -0.46460 + 120.0 -45.0 -0.38665 + 135.0 -45.0 -0.55232 + 150.0 -45.0 -0.67078 + 165.0 -45.0 -0.67830 + 180.0 -45.0 -0.67275 + -180.0 -30.0 -2.46944 + -165.0 -30.0 -2.32595 + -150.0 -30.0 -1.71439 + -135.0 -30.0 -2.48703 + -120.0 -30.0 -2.56054 + -105.0 -30.0 -2.46215 + -90.0 -30.0 -2.37111 + -75.0 -30.0 -2.19037 + -60.0 -30.0 -1.62432 + -45.0 -30.0 -0.72370 + -30.0 -30.0 0.35895 + -15.0 -30.0 1.35947 + 0.0 -30.0 2.12358 + 15.0 -30.0 2.36496 + 30.0 -30.0 1.96636 + 45.0 -30.0 1.05275 + 60.0 -30.0 -0.26183 + 75.0 -30.0 -1.16368 + 90.0 -30.0 -1.65442 + 105.0 -30.0 -1.64196 + 120.0 -30.0 -1.86484 + 135.0 -30.0 -2.09366 + 150.0 -30.0 -2.28268 + 165.0 -30.0 -2.41932 + 180.0 -30.0 -2.46944 + -180.0 -15.0 -3.82546 + -165.0 -15.0 -3.22967 + -150.0 -15.0 -3.93518 + -135.0 -15.0 -3.85949 + -120.0 -15.0 -3.58321 + -105.0 -15.0 -3.28549 + -90.0 -15.0 -3.01617 + -75.0 -15.0 -2.60005 + -60.0 -15.0 -1.92147 + -45.0 -15.0 -1.14234 + -30.0 -15.0 -0.00873 + -15.0 -15.0 1.14445 + 0.0 -15.0 1.77335 + 15.0 -15.0 1.79047 + 30.0 -15.0 1.09507 + 45.0 -15.0 -0.16297 + 60.0 -15.0 -1.43516 + 75.0 -15.0 -2.26699 + 90.0 -15.0 -2.45933 + 105.0 -15.0 -2.70542 + 120.0 -15.0 -3.03929 + 135.0 -15.0 -3.35545 + 150.0 -15.0 -3.62364 + 165.0 -15.0 -3.79758 + 180.0 -15.0 -3.82546 + -180.0 0.0 -3.82990 + -165.0 0.0 -4.37645 + -150.0 0.0 -4.29456 + -135.0 0.0 -4.01846 + -120.0 0.0 -3.66843 + -105.0 0.0 -3.31240 + -90.0 0.0 -2.96646 + -75.0 0.0 -2.58028 + -60.0 0.0 -2.08554 + -45.0 0.0 -0.99050 + -30.0 0.0 0.42261 + -15.0 0.0 1.35374 + 0.0 0.0 1.69885 + 15.0 0.0 1.35374 + 30.0 0.0 0.42261 + 45.0 0.0 -1.00310 + 60.0 0.0 -2.08554 + 75.0 0.0 -2.58028 + 90.0 0.0 -2.96646 + 105.0 0.0 -3.31240 + 120.0 0.0 -3.66843 + 135.0 0.0 -4.01846 + 150.0 0.0 -4.29456 + 165.0 0.0 -4.37645 + 180.0 0.0 -3.82990 + -180.0 15.0 -3.82546 + -165.0 15.0 -3.79758 + -150.0 15.0 -3.62364 + -135.0 15.0 -3.35545 + -120.0 15.0 -3.03929 + -105.0 15.0 -2.70542 + -90.0 15.0 -2.45933 + -75.0 15.0 -2.26699 + -60.0 15.0 -1.43516 + -45.0 15.0 -0.16297 + -30.0 15.0 1.09507 + -15.0 15.0 1.79047 + 0.0 15.0 1.77335 + 15.0 15.0 1.14445 + 30.0 15.0 -0.00873 + 45.0 15.0 -1.14234 + 60.0 15.0 -1.92147 + 75.0 15.0 -2.60005 + 90.0 15.0 -3.01617 + 105.0 15.0 -3.28549 + 120.0 15.0 -3.58321 + 135.0 15.0 -3.85949 + 150.0 15.0 -3.93518 + 165.0 15.0 -3.23037 + 180.0 15.0 -3.82546 + -180.0 30.0 -2.46944 + -165.0 30.0 -2.41932 + -150.0 30.0 -2.28268 + -135.0 30.0 -2.09366 + -120.0 30.0 -1.86484 + -105.0 30.0 -1.64196 + -90.0 30.0 -1.65442 + -75.0 30.0 -1.16368 + -60.0 30.0 -0.26183 + -45.0 30.0 1.05275 + -30.0 30.0 1.96636 + -15.0 30.0 2.36496 + 0.0 30.0 2.12358 + 15.0 30.0 1.35947 + 30.0 30.0 0.35055 + 45.0 30.0 -0.72370 + 60.0 30.0 -1.62432 + 75.0 30.0 -2.19037 + 90.0 30.0 -2.37111 + 105.0 30.0 -2.46215 + 120.0 30.0 -2.56054 + 135.0 30.0 -2.48703 + 150.0 30.0 -1.70729 + 165.0 30.0 -2.32595 + 180.0 30.0 -2.46944 + -180.0 45.0 -0.67275 + -165.0 45.0 -0.67830 + -150.0 45.0 -0.67078 + -135.0 45.0 -0.55232 + -120.0 45.0 -0.38665 + -105.0 45.0 -0.46460 + -90.0 45.0 -0.42237 + -75.0 45.0 0.20720 + -60.0 45.0 1.16243 + -45.0 45.0 2.19151 + -30.0 45.0 2.85045 + -15.0 45.0 3.13379 + 0.0 45.0 2.78505 + 15.0 45.0 2.06071 + 30.0 45.0 0.77634 + 45.0 45.0 -0.24576 + 60.0 45.0 -0.87844 + 75.0 45.0 -1.06430 + 90.0 45.0 -0.99538 + 105.0 45.0 -0.80922 + 120.0 45.0 -0.51470 + 135.0 45.0 -0.01106 + 150.0 45.0 -0.42200 + 165.0 45.0 -0.59212 + 180.0 45.0 -0.67275 + -180.0 60.0 0.94133 + -165.0 60.0 0.78581 + -150.0 60.0 0.75367 + -135.0 60.0 0.79351 + -120.0 60.0 0.77935 + -105.0 60.0 0.57769 + -90.0 60.0 0.79250 + -75.0 60.0 1.36042 + -60.0 60.0 1.94715 + -45.0 60.0 2.89718 + -30.0 60.0 3.40120 + -15.0 60.0 3.78367 + 0.0 60.0 3.54214 + 15.0 60.0 2.19742 + 30.0 60.0 1.24745 + 45.0 60.0 0.74572 + 60.0 60.0 0.56577 + 75.0 60.0 0.57562 + 90.0 60.0 0.79628 + 105.0 60.0 1.25994 + 120.0 60.0 0.94411 + 135.0 60.0 0.96211 + 150.0 60.0 1.06365 + 165.0 60.0 1.07716 + 180.0 60.0 0.94133 + -180.0 75.0 1.80621 + -165.0 75.0 1.64225 + -150.0 75.0 1.59747 + -135.0 75.0 1.53314 + -120.0 75.0 1.36656 + -105.0 75.0 1.09103 + -90.0 75.0 1.27852 + -75.0 75.0 1.66472 + -60.0 75.0 2.31976 + -45.0 75.0 2.86443 + -30.0 75.0 3.57523 + -15.0 75.0 4.06613 + 0.0 75.0 3.24329 + 15.0 75.0 2.40295 + 30.0 75.0 2.13049 + 45.0 75.0 2.21268 + 60.0 75.0 2.17320 + 75.0 75.0 2.16375 + 90.0 75.0 1.43311 + 105.0 75.0 1.22509 + 120.0 75.0 1.29208 + 135.0 75.0 1.68691 + 150.0 75.0 2.03556 + 165.0 75.0 2.08080 + 180.0 75.0 1.80621 + -180.0 90.0 1.90401 + -165.0 90.0 1.82118 + -150.0 90.0 1.81755 + -135.0 90.0 1.62671 + -120.0 90.0 1.41199 + -105.0 90.0 1.17449 + -90.0 90.0 1.13012 + -75.0 90.0 1.33310 + -60.0 90.0 1.57482 + -45.0 90.0 2.15793 + -30.0 90.0 2.79428 + -15.0 90.0 3.09474 + 0.0 90.0 2.65047 + 15.0 90.0 2.62493 + 30.0 90.0 3.09673 + 45.0 90.0 3.45522 + 60.0 90.0 2.45075 + 75.0 90.0 1.23397 + 90.0 90.0 0.90562 + 105.0 90.0 1.02391 + 120.0 90.0 1.35280 + 135.0 90.0 1.79055 + 150.0 90.0 2.29924 + 165.0 90.0 2.03939 + 180.0 90.0 1.90401 + -180.0 105.0 1.42827 + -165.0 105.0 1.53133 + -150.0 105.0 1.50886 + -135.0 105.0 1.51499 + -120.0 105.0 1.33189 + -105.0 105.0 1.02077 + -90.0 105.0 0.60470 + -75.0 105.0 0.46027 + -60.0 105.0 0.55065 + -45.0 105.0 0.92486 + -30.0 105.0 1.43567 + -15.0 105.0 1.65224 + 0.0 105.0 1.95317 + 15.0 105.0 2.65211 + 30.0 105.0 3.58847 + 45.0 105.0 2.98189 + 60.0 105.0 1.22814 + 75.0 105.0 0.20821 + 90.0 105.0 0.20084 + 105.0 105.0 0.56475 + 120.0 105.0 1.03764 + 135.0 105.0 1.64917 + 150.0 105.0 1.72204 + 165.0 105.0 1.50406 + 180.0 105.0 1.42827 + -180.0 120.0 0.76282 + -165.0 120.0 1.05012 + -150.0 120.0 1.15910 + -135.0 120.0 1.16949 + -120.0 120.0 0.97289 + -105.0 120.0 0.54550 + -90.0 120.0 0.18803 + -75.0 120.0 -0.35755 + -60.0 120.0 -0.64487 + -45.0 120.0 -0.49787 + -30.0 120.0 -0.07964 + -15.0 120.0 0.51132 + 0.0 120.0 1.40660 + 15.0 120.0 2.47433 + 30.0 120.0 3.49117 + 45.0 120.0 1.42775 + 60.0 120.0 -0.44624 + 75.0 120.0 -0.87022 + 90.0 120.0 -0.55868 + 105.0 120.0 -0.17578 + 120.0 120.0 0.46767 + 135.0 120.0 0.80302 + 150.0 120.0 0.73536 + 165.0 120.0 0.65049 + 180.0 120.0 0.76282 + -180.0 135.0 0.22137 + -165.0 135.0 0.59900 + -150.0 135.0 0.82176 + -135.0 135.0 0.78961 + -120.0 135.0 0.35059 + -105.0 135.0 -0.14353 + -90.0 135.0 -0.54882 + -75.0 135.0 -1.11846 + -60.0 135.0 -1.54005 + -45.0 135.0 -1.57764 + -30.0 135.0 -1.08446 + -15.0 135.0 -0.13409 + 0.0 135.0 1.01469 + 15.0 135.0 2.08125 + 30.0 135.0 2.15102 + 45.0 135.0 -0.87317 + 60.0 135.0 -1.99291 + 75.0 135.0 -1.97985 + 90.0 135.0 -1.48283 + 105.0 135.0 -0.91494 + 120.0 135.0 -0.45372 + 135.0 135.0 -0.25120 + 150.0 135.0 -0.25069 + 165.0 135.0 -0.11507 + 180.0 135.0 0.22137 + -180.0 150.0 -0.05487 + -165.0 150.0 0.30007 + -150.0 150.0 0.37394 + -135.0 150.0 0.15792 + -120.0 150.0 -0.27502 + -105.0 150.0 -0.79693 + -90.0 150.0 -1.32072 + -75.0 150.0 -1.85418 + -60.0 150.0 -2.27657 + -45.0 150.0 -2.28172 + -30.0 150.0 -1.60792 + -15.0 150.0 -0.47503 + 0.0 150.0 0.68197 + 15.0 150.0 1.60921 + 30.0 150.0 -0.65594 + 45.0 150.0 -2.36553 + 60.0 150.0 -2.95919 + 75.0 150.0 -2.73078 + 90.0 150.0 -2.17397 + 105.0 150.0 -1.65041 + 120.0 150.0 -1.25474 + 135.0 150.0 -1.02443 + 150.0 150.0 -0.83418 + 165.0 150.0 -0.49639 + 180.0 150.0 -0.05487 + -180.0 165.0 -0.03043 + -165.0 165.0 0.10146 + -150.0 165.0 -0.04055 + -135.0 165.0 -0.44166 + -120.0 165.0 -0.94989 + -105.0 165.0 -1.47132 + -90.0 165.0 -1.96898 + -75.0 165.0 -2.45910 + -60.0 165.0 -2.82977 + -45.0 165.0 -2.72832 + -30.0 165.0 -1.85441 + -15.0 165.0 -0.59328 + 0.0 165.0 0.47583 + 15.0 165.0 0.28654 + 30.0 165.0 -1.66034 + 45.0 165.0 -2.85897 + 60.0 165.0 -3.27921 + 75.0 165.0 -2.96238 + 90.0 165.0 -2.44752 + 105.0 165.0 -1.99117 + 120.0 165.0 -1.60564 + 135.0 165.0 -1.22723 + 150.0 165.0 -0.84288 + 165.0 165.0 -0.40282 + 180.0 165.0 -0.03043 + -180.0 180.0 0.00000 + -165.0 180.0 -0.15918 + -150.0 180.0 -0.46924 + -135.0 180.0 -0.94887 + -120.0 180.0 -1.41919 + -105.0 180.0 -1.89608 + -90.0 180.0 -2.35024 + -75.0 180.0 -2.81648 + -60.0 180.0 -3.17758 + -45.0 180.0 -2.91092 + -30.0 180.0 -1.84916 + -15.0 180.0 -0.61868 + 0.0 180.0 1.44957 + 15.0 180.0 -0.61868 + 30.0 180.0 -1.84916 + 45.0 180.0 -2.91092 + 60.0 180.0 -3.17758 + 75.0 180.0 -2.81793 + 90.0 180.0 -2.34954 + 105.0 180.0 -1.91578 + 120.0 180.0 -1.41919 + 135.0 180.0 -0.94887 + 150.0 180.0 -0.46924 + 165.0 180.0 -0.15918 + 180.0 180.0 0.00000 + +tortors 3 1 2 3 15 25 25 + -180.0 -180.0 0.00000 + -165.0 -180.0 -0.15918 + -150.0 -180.0 -0.46924 + -135.0 -180.0 -0.94887 + -120.0 -180.0 -1.41919 + -105.0 -180.0 -1.89608 + -90.0 -180.0 -2.35024 + -75.0 -180.0 -2.81648 + -60.0 -180.0 -3.17758 + -45.0 -180.0 -2.91092 + -30.0 -180.0 -1.84916 + -15.0 -180.0 -0.61868 + 0.0 -180.0 1.44957 + 15.0 -180.0 -0.61868 + 30.0 -180.0 -1.84916 + 45.0 -180.0 -2.91092 + 60.0 -180.0 -3.17758 + 75.0 -180.0 -2.81793 + 90.0 -180.0 -2.34954 + 105.0 -180.0 -1.91578 + 120.0 -180.0 -1.41919 + 135.0 -180.0 -0.94887 + 150.0 -180.0 -0.46924 + 165.0 -180.0 -0.15918 + 180.0 -180.0 0.00000 + -180.0 -165.0 -0.03043 + -165.0 -165.0 -0.40282 + -150.0 -165.0 -0.84288 + -135.0 -165.0 -1.22723 + -120.0 -165.0 -1.58634 + -105.0 -165.0 -1.98317 + -90.0 -165.0 -2.46682 + -75.0 -165.0 -2.96238 + -60.0 -165.0 -3.27921 + -45.0 -165.0 -2.85897 + -30.0 -165.0 -1.66034 + -15.0 -165.0 0.28654 + 0.0 -165.0 0.47583 + 15.0 -165.0 -0.59328 + 30.0 -165.0 -1.85441 + 45.0 -165.0 -2.72832 + 60.0 -165.0 -2.82977 + 75.0 -165.0 -2.43750 + 90.0 -165.0 -1.97978 + 105.0 -165.0 -1.47132 + 120.0 -165.0 -0.94989 + 135.0 -165.0 -0.44166 + 150.0 -165.0 -0.04055 + 165.0 -165.0 0.10146 + 180.0 -165.0 -0.03043 + -180.0 -150.0 -0.05487 + -165.0 -150.0 -0.49639 + -150.0 -150.0 -0.83418 + -135.0 -150.0 -1.02443 + -120.0 -150.0 -1.24614 + -105.0 -150.0 -1.65671 + -90.0 -150.0 -2.17397 + -75.0 -150.0 -2.73078 + -60.0 -150.0 -2.95919 + -45.0 -150.0 -2.36553 + -30.0 -150.0 -0.65594 + -15.0 -150.0 1.60921 + 0.0 -150.0 0.68197 + 15.0 -150.0 -0.47503 + 30.0 -150.0 -1.60792 + 45.0 -150.0 -2.28172 + 60.0 -150.0 -2.27657 + 75.0 -150.0 -1.84368 + 90.0 -150.0 -1.32072 + 105.0 -150.0 -0.79693 + 120.0 -150.0 -0.27502 + 135.0 -150.0 0.15792 + 150.0 -150.0 0.37394 + 165.0 -150.0 0.30007 + 180.0 -150.0 -0.05487 + -180.0 -135.0 0.22137 + -165.0 -135.0 -0.11507 + -150.0 -135.0 -0.25069 + -135.0 -135.0 -0.25120 + -120.0 -135.0 -0.45372 + -105.0 -135.0 -0.91494 + -90.0 -135.0 -1.48283 + -75.0 -135.0 -1.97985 + -60.0 -135.0 -1.99291 + -45.0 -135.0 -0.87317 + -30.0 -135.0 2.15102 + -15.0 -135.0 2.08125 + 0.0 -135.0 1.01469 + 15.0 -135.0 -0.13409 + 30.0 -135.0 -1.08446 + 45.0 -135.0 -1.57764 + 60.0 -135.0 -1.54005 + 75.0 -135.0 -1.11846 + 90.0 -135.0 -0.54882 + 105.0 -135.0 -0.14353 + 120.0 -135.0 0.35059 + 135.0 -135.0 0.78961 + 150.0 -135.0 0.82176 + 165.0 -135.0 0.59900 + 180.0 -135.0 0.22137 + -180.0 -120.0 0.76282 + -165.0 -120.0 0.65049 + -150.0 -120.0 0.73226 + -135.0 -120.0 0.80302 + -120.0 -120.0 0.46767 + -105.0 -120.0 -0.17578 + -90.0 -120.0 -0.55868 + -75.0 -120.0 -0.87022 + -60.0 -120.0 -0.44624 + -45.0 -120.0 1.42775 + -30.0 -120.0 3.49117 + -15.0 -120.0 2.47433 + 0.0 -120.0 1.40660 + 15.0 -120.0 0.51132 + 30.0 -120.0 -0.07964 + 45.0 -120.0 -0.49787 + 60.0 -120.0 -0.64487 + 75.0 -120.0 -0.35755 + 90.0 -120.0 0.18803 + 105.0 -120.0 0.54550 + 120.0 -120.0 0.97289 + 135.0 -120.0 1.16949 + 150.0 -120.0 1.15910 + 165.0 -120.0 1.05012 + 180.0 -120.0 0.76282 + -180.0 -105.0 1.42827 + -165.0 -105.0 1.50406 + -150.0 -105.0 1.72284 + -135.0 -105.0 1.64917 + -120.0 -105.0 1.03764 + -105.0 -105.0 0.56475 + -90.0 -105.0 0.20084 + -75.0 -105.0 0.20821 + -60.0 -105.0 1.22814 + -45.0 -105.0 2.98189 + -30.0 -105.0 3.57647 + -15.0 -105.0 2.65211 + 0.0 -105.0 1.95317 + 15.0 -105.0 1.65224 + 30.0 -105.0 1.43567 + 45.0 -105.0 0.92486 + 60.0 -105.0 0.55065 + 75.0 -105.0 0.46027 + 90.0 -105.0 0.60470 + 105.0 -105.0 1.02077 + 120.0 -105.0 1.33189 + 135.0 -105.0 1.51499 + 150.0 -105.0 1.50886 + 165.0 -105.0 1.53133 + 180.0 -105.0 1.42827 + -180.0 -90.0 1.90401 + -165.0 -90.0 2.03939 + -150.0 -90.0 2.29924 + -135.0 -90.0 1.79055 + -120.0 -90.0 1.35280 + -105.0 -90.0 1.02391 + -90.0 -90.0 0.90562 + -75.0 -90.0 1.23397 + -60.0 -90.0 2.45075 + -45.0 -90.0 3.45522 + -30.0 -90.0 3.09983 + -15.0 -90.0 2.62493 + 0.0 -90.0 2.65047 + 15.0 -90.0 3.09474 + 30.0 -90.0 2.79428 + 45.0 -90.0 2.15793 + 60.0 -90.0 1.57482 + 75.0 -90.0 1.33310 + 90.0 -90.0 1.13012 + 105.0 -90.0 1.17449 + 120.0 -90.0 1.41199 + 135.0 -90.0 1.62671 + 150.0 -90.0 1.81755 + 165.0 -90.0 1.82118 + 180.0 -90.0 1.90401 + -180.0 -75.0 1.80621 + -165.0 -75.0 2.08080 + -150.0 -75.0 2.03556 + -135.0 -75.0 1.68691 + -120.0 -75.0 1.29208 + -105.0 -75.0 1.22509 + -90.0 -75.0 1.43311 + -75.0 -75.0 2.16375 + -60.0 -75.0 2.17320 + -45.0 -75.0 2.21268 + -30.0 -75.0 2.13049 + -15.0 -75.0 2.40205 + 0.0 -75.0 3.24329 + 15.0 -75.0 4.06613 + 30.0 -75.0 3.57523 + 45.0 -75.0 2.86443 + 60.0 -75.0 2.31976 + 75.0 -75.0 1.66472 + 90.0 -75.0 1.27852 + 105.0 -75.0 1.09103 + 120.0 -75.0 1.36656 + 135.0 -75.0 1.53314 + 150.0 -75.0 1.59747 + 165.0 -75.0 1.64225 + 180.0 -75.0 1.80621 + -180.0 -60.0 0.94133 + -165.0 -60.0 1.07716 + -150.0 -60.0 1.06365 + -135.0 -60.0 0.96211 + -120.0 -60.0 0.94411 + -105.0 -60.0 1.25994 + -90.0 -60.0 0.79628 + -75.0 -60.0 0.57562 + -60.0 -60.0 0.56577 + -45.0 -60.0 0.74572 + -30.0 -60.0 1.24745 + -15.0 -60.0 2.21612 + 0.0 -60.0 3.54214 + 15.0 -60.0 3.78367 + 30.0 -60.0 3.40120 + 45.0 -60.0 2.89718 + 60.0 -60.0 1.94715 + 75.0 -60.0 1.36042 + 90.0 -60.0 0.79250 + 105.0 -60.0 0.57769 + 120.0 -60.0 0.77935 + 135.0 -60.0 0.79351 + 150.0 -60.0 0.75367 + 165.0 -60.0 0.78581 + 180.0 -60.0 0.94133 + -180.0 -45.0 -0.67275 + -165.0 -45.0 -0.59212 + -150.0 -45.0 -0.42200 + -135.0 -45.0 -0.01106 + -120.0 -45.0 -0.51470 + -105.0 -45.0 -0.80922 + -90.0 -45.0 -0.99538 + -75.0 -45.0 -1.06430 + -60.0 -45.0 -0.87844 + -45.0 -45.0 -0.24576 + -30.0 -45.0 0.77634 + -15.0 -45.0 2.05251 + 0.0 -45.0 2.78505 + 15.0 -45.0 3.13379 + 30.0 -45.0 2.85045 + 45.0 -45.0 2.19151 + 60.0 -45.0 1.16243 + 75.0 -45.0 0.20720 + 90.0 -45.0 -0.42237 + 105.0 -45.0 -0.46460 + 120.0 -45.0 -0.38665 + 135.0 -45.0 -0.55232 + 150.0 -45.0 -0.67078 + 165.0 -45.0 -0.67830 + 180.0 -45.0 -0.67275 + -180.0 -30.0 -2.46944 + -165.0 -30.0 -2.32595 + -150.0 -30.0 -1.71439 + -135.0 -30.0 -2.48703 + -120.0 -30.0 -2.56054 + -105.0 -30.0 -2.46215 + -90.0 -30.0 -2.37111 + -75.0 -30.0 -2.19037 + -60.0 -30.0 -1.62432 + -45.0 -30.0 -0.72370 + -30.0 -30.0 0.35895 + -15.0 -30.0 1.35947 + 0.0 -30.0 2.12358 + 15.0 -30.0 2.36496 + 30.0 -30.0 1.96636 + 45.0 -30.0 1.05275 + 60.0 -30.0 -0.26183 + 75.0 -30.0 -1.16368 + 90.0 -30.0 -1.65442 + 105.0 -30.0 -1.64196 + 120.0 -30.0 -1.86484 + 135.0 -30.0 -2.09366 + 150.0 -30.0 -2.28268 + 165.0 -30.0 -2.41932 + 180.0 -30.0 -2.46944 + -180.0 -15.0 -3.82546 + -165.0 -15.0 -3.22967 + -150.0 -15.0 -3.93518 + -135.0 -15.0 -3.85949 + -120.0 -15.0 -3.58321 + -105.0 -15.0 -3.28549 + -90.0 -15.0 -3.01617 + -75.0 -15.0 -2.60005 + -60.0 -15.0 -1.92147 + -45.0 -15.0 -1.14234 + -30.0 -15.0 -0.00873 + -15.0 -15.0 1.14445 + 0.0 -15.0 1.77335 + 15.0 -15.0 1.79047 + 30.0 -15.0 1.09507 + 45.0 -15.0 -0.16297 + 60.0 -15.0 -1.43516 + 75.0 -15.0 -2.26699 + 90.0 -15.0 -2.45933 + 105.0 -15.0 -2.70542 + 120.0 -15.0 -3.03929 + 135.0 -15.0 -3.35545 + 150.0 -15.0 -3.62364 + 165.0 -15.0 -3.79758 + 180.0 -15.0 -3.82546 + -180.0 0.0 -3.82990 + -165.0 0.0 -4.37645 + -150.0 0.0 -4.29456 + -135.0 0.0 -4.01846 + -120.0 0.0 -3.66843 + -105.0 0.0 -3.31240 + -90.0 0.0 -2.96646 + -75.0 0.0 -2.58028 + -60.0 0.0 -2.08554 + -45.0 0.0 -0.99050 + -30.0 0.0 0.42261 + -15.0 0.0 1.35374 + 0.0 0.0 1.69885 + 15.0 0.0 1.35374 + 30.0 0.0 0.42261 + 45.0 0.0 -1.00310 + 60.0 0.0 -2.08554 + 75.0 0.0 -2.58028 + 90.0 0.0 -2.96646 + 105.0 0.0 -3.31240 + 120.0 0.0 -3.66843 + 135.0 0.0 -4.01846 + 150.0 0.0 -4.29456 + 165.0 0.0 -4.37645 + 180.0 0.0 -3.82990 + -180.0 15.0 -3.82546 + -165.0 15.0 -3.79758 + -150.0 15.0 -3.62364 + -135.0 15.0 -3.35545 + -120.0 15.0 -3.03929 + -105.0 15.0 -2.70542 + -90.0 15.0 -2.45933 + -75.0 15.0 -2.26699 + -60.0 15.0 -1.43516 + -45.0 15.0 -0.16297 + -30.0 15.0 1.09507 + -15.0 15.0 1.79047 + 0.0 15.0 1.77335 + 15.0 15.0 1.14445 + 30.0 15.0 -0.00873 + 45.0 15.0 -1.14234 + 60.0 15.0 -1.92147 + 75.0 15.0 -2.60005 + 90.0 15.0 -3.01617 + 105.0 15.0 -3.28549 + 120.0 15.0 -3.58321 + 135.0 15.0 -3.85949 + 150.0 15.0 -3.93518 + 165.0 15.0 -3.23037 + 180.0 15.0 -3.82546 + -180.0 30.0 -2.46944 + -165.0 30.0 -2.41932 + -150.0 30.0 -2.28268 + -135.0 30.0 -2.09366 + -120.0 30.0 -1.86484 + -105.0 30.0 -1.64196 + -90.0 30.0 -1.65442 + -75.0 30.0 -1.16368 + -60.0 30.0 -0.26183 + -45.0 30.0 1.05275 + -30.0 30.0 1.96636 + -15.0 30.0 2.36496 + 0.0 30.0 2.12358 + 15.0 30.0 1.35947 + 30.0 30.0 0.35055 + 45.0 30.0 -0.72370 + 60.0 30.0 -1.62432 + 75.0 30.0 -2.19037 + 90.0 30.0 -2.37111 + 105.0 30.0 -2.46215 + 120.0 30.0 -2.56054 + 135.0 30.0 -2.48703 + 150.0 30.0 -1.70729 + 165.0 30.0 -2.32595 + 180.0 30.0 -2.46944 + -180.0 45.0 -0.67275 + -165.0 45.0 -0.67830 + -150.0 45.0 -0.67078 + -135.0 45.0 -0.55232 + -120.0 45.0 -0.38665 + -105.0 45.0 -0.46460 + -90.0 45.0 -0.42237 + -75.0 45.0 0.20720 + -60.0 45.0 1.16243 + -45.0 45.0 2.19151 + -30.0 45.0 2.85045 + -15.0 45.0 3.13379 + 0.0 45.0 2.78505 + 15.0 45.0 2.06071 + 30.0 45.0 0.77634 + 45.0 45.0 -0.24576 + 60.0 45.0 -0.87844 + 75.0 45.0 -1.06430 + 90.0 45.0 -0.99538 + 105.0 45.0 -0.80922 + 120.0 45.0 -0.51470 + 135.0 45.0 -0.01106 + 150.0 45.0 -0.42200 + 165.0 45.0 -0.59212 + 180.0 45.0 -0.67275 + -180.0 60.0 0.94133 + -165.0 60.0 0.78581 + -150.0 60.0 0.75367 + -135.0 60.0 0.79351 + -120.0 60.0 0.77935 + -105.0 60.0 0.57769 + -90.0 60.0 0.79250 + -75.0 60.0 1.36042 + -60.0 60.0 1.94715 + -45.0 60.0 2.89718 + -30.0 60.0 3.40120 + -15.0 60.0 3.78367 + 0.0 60.0 3.54214 + 15.0 60.0 2.19742 + 30.0 60.0 1.24745 + 45.0 60.0 0.74572 + 60.0 60.0 0.56577 + 75.0 60.0 0.57562 + 90.0 60.0 0.79628 + 105.0 60.0 1.25994 + 120.0 60.0 0.94411 + 135.0 60.0 0.96211 + 150.0 60.0 1.06365 + 165.0 60.0 1.07716 + 180.0 60.0 0.94133 + -180.0 75.0 1.80621 + -165.0 75.0 1.64225 + -150.0 75.0 1.59747 + -135.0 75.0 1.53314 + -120.0 75.0 1.36656 + -105.0 75.0 1.09103 + -90.0 75.0 1.27852 + -75.0 75.0 1.66472 + -60.0 75.0 2.31976 + -45.0 75.0 2.86443 + -30.0 75.0 3.57523 + -15.0 75.0 4.06613 + 0.0 75.0 3.24329 + 15.0 75.0 2.40295 + 30.0 75.0 2.13049 + 45.0 75.0 2.21268 + 60.0 75.0 2.17320 + 75.0 75.0 2.16375 + 90.0 75.0 1.43311 + 105.0 75.0 1.22509 + 120.0 75.0 1.29208 + 135.0 75.0 1.68691 + 150.0 75.0 2.03556 + 165.0 75.0 2.08080 + 180.0 75.0 1.80621 + -180.0 90.0 1.90401 + -165.0 90.0 1.82118 + -150.0 90.0 1.81755 + -135.0 90.0 1.62671 + -120.0 90.0 1.41199 + -105.0 90.0 1.17449 + -90.0 90.0 1.13012 + -75.0 90.0 1.33310 + -60.0 90.0 1.57482 + -45.0 90.0 2.15793 + -30.0 90.0 2.79428 + -15.0 90.0 3.09474 + 0.0 90.0 2.65047 + 15.0 90.0 2.62493 + 30.0 90.0 3.09673 + 45.0 90.0 3.45522 + 60.0 90.0 2.45075 + 75.0 90.0 1.23397 + 90.0 90.0 0.90562 + 105.0 90.0 1.02391 + 120.0 90.0 1.35280 + 135.0 90.0 1.79055 + 150.0 90.0 2.29924 + 165.0 90.0 2.03939 + 180.0 90.0 1.90401 + -180.0 105.0 1.42827 + -165.0 105.0 1.53133 + -150.0 105.0 1.50886 + -135.0 105.0 1.51499 + -120.0 105.0 1.33189 + -105.0 105.0 1.02077 + -90.0 105.0 0.60470 + -75.0 105.0 0.46027 + -60.0 105.0 0.55065 + -45.0 105.0 0.92486 + -30.0 105.0 1.43567 + -15.0 105.0 1.65224 + 0.0 105.0 1.95317 + 15.0 105.0 2.65211 + 30.0 105.0 3.58847 + 45.0 105.0 2.98189 + 60.0 105.0 1.22814 + 75.0 105.0 0.20821 + 90.0 105.0 0.20084 + 105.0 105.0 0.56475 + 120.0 105.0 1.03764 + 135.0 105.0 1.64917 + 150.0 105.0 1.72204 + 165.0 105.0 1.50406 + 180.0 105.0 1.42827 + -180.0 120.0 0.76282 + -165.0 120.0 1.05012 + -150.0 120.0 1.15910 + -135.0 120.0 1.16949 + -120.0 120.0 0.97289 + -105.0 120.0 0.54550 + -90.0 120.0 0.18803 + -75.0 120.0 -0.35755 + -60.0 120.0 -0.64487 + -45.0 120.0 -0.49787 + -30.0 120.0 -0.07964 + -15.0 120.0 0.51132 + 0.0 120.0 1.40660 + 15.0 120.0 2.47433 + 30.0 120.0 3.49117 + 45.0 120.0 1.42775 + 60.0 120.0 -0.44624 + 75.0 120.0 -0.87022 + 90.0 120.0 -0.55868 + 105.0 120.0 -0.17578 + 120.0 120.0 0.46767 + 135.0 120.0 0.80302 + 150.0 120.0 0.73536 + 165.0 120.0 0.65049 + 180.0 120.0 0.76282 + -180.0 135.0 0.22137 + -165.0 135.0 0.59900 + -150.0 135.0 0.82176 + -135.0 135.0 0.78961 + -120.0 135.0 0.35059 + -105.0 135.0 -0.14353 + -90.0 135.0 -0.54882 + -75.0 135.0 -1.11846 + -60.0 135.0 -1.54005 + -45.0 135.0 -1.57764 + -30.0 135.0 -1.08446 + -15.0 135.0 -0.13409 + 0.0 135.0 1.01469 + 15.0 135.0 2.08125 + 30.0 135.0 2.15102 + 45.0 135.0 -0.87317 + 60.0 135.0 -1.99291 + 75.0 135.0 -1.97985 + 90.0 135.0 -1.48283 + 105.0 135.0 -0.91494 + 120.0 135.0 -0.45372 + 135.0 135.0 -0.25120 + 150.0 135.0 -0.25069 + 165.0 135.0 -0.11507 + 180.0 135.0 0.22137 + -180.0 150.0 -0.05487 + -165.0 150.0 0.30007 + -150.0 150.0 0.37394 + -135.0 150.0 0.15792 + -120.0 150.0 -0.27502 + -105.0 150.0 -0.79693 + -90.0 150.0 -1.32072 + -75.0 150.0 -1.85418 + -60.0 150.0 -2.27657 + -45.0 150.0 -2.28172 + -30.0 150.0 -1.60792 + -15.0 150.0 -0.47503 + 0.0 150.0 0.68197 + 15.0 150.0 1.60921 + 30.0 150.0 -0.65594 + 45.0 150.0 -2.36553 + 60.0 150.0 -2.95919 + 75.0 150.0 -2.73078 + 90.0 150.0 -2.17397 + 105.0 150.0 -1.65041 + 120.0 150.0 -1.25474 + 135.0 150.0 -1.02443 + 150.0 150.0 -0.83418 + 165.0 150.0 -0.49639 + 180.0 150.0 -0.05487 + -180.0 165.0 -0.03043 + -165.0 165.0 0.10146 + -150.0 165.0 -0.04055 + -135.0 165.0 -0.44166 + -120.0 165.0 -0.94989 + -105.0 165.0 -1.47132 + -90.0 165.0 -1.96898 + -75.0 165.0 -2.45910 + -60.0 165.0 -2.82977 + -45.0 165.0 -2.72832 + -30.0 165.0 -1.85441 + -15.0 165.0 -0.59328 + 0.0 165.0 0.47583 + 15.0 165.0 0.28654 + 30.0 165.0 -1.66034 + 45.0 165.0 -2.85897 + 60.0 165.0 -3.27921 + 75.0 165.0 -2.96238 + 90.0 165.0 -2.44752 + 105.0 165.0 -1.99117 + 120.0 165.0 -1.60564 + 135.0 165.0 -1.22723 + 150.0 165.0 -0.84288 + 165.0 165.0 -0.40282 + 180.0 165.0 -0.03043 + -180.0 180.0 0.00000 + -165.0 180.0 -0.15918 + -150.0 180.0 -0.46924 + -135.0 180.0 -0.94887 + -120.0 180.0 -1.41919 + -105.0 180.0 -1.89608 + -90.0 180.0 -2.35024 + -75.0 180.0 -2.81648 + -60.0 180.0 -3.17758 + -45.0 180.0 -2.91092 + -30.0 180.0 -1.84916 + -15.0 180.0 -0.61868 + 0.0 180.0 1.44957 + 15.0 180.0 -0.61868 + 30.0 180.0 -1.84916 + 45.0 180.0 -2.91092 + 60.0 180.0 -3.17758 + 75.0 180.0 -2.81793 + 90.0 180.0 -2.34954 + 105.0 180.0 -1.91578 + 120.0 180.0 -1.41919 + 135.0 180.0 -0.94887 + 150.0 180.0 -0.46924 + 165.0 180.0 -0.15918 + 180.0 180.0 0.00000 + +tortors 3 1 7 3 1 25 25 + -180.0 -180.0 0.98936 + -165.0 -180.0 0.76408 + -150.0 -180.0 0.21674 + -135.0 -180.0 -0.18200 + -120.0 -180.0 -0.37729 + -105.0 -180.0 -0.47834 + -90.0 -180.0 -0.59267 + -75.0 -180.0 -0.93985 + -60.0 -180.0 -1.55558 + -45.0 -180.0 -2.01849 + -30.0 -180.0 -1.94076 + -15.0 -180.0 -1.46400 + 0.0 -180.0 0.18253 + 15.0 -180.0 -0.80364 + 30.0 -180.0 -1.32974 + 45.0 -180.0 -1.31658 + 60.0 -180.0 -0.50140 + 75.0 -180.0 0.20431 + 90.0 -180.0 0.39356 + 105.0 -180.0 0.20356 + 120.0 -180.0 -0.16993 + 135.0 -180.0 -0.22733 + 150.0 -180.0 0.13703 + 165.0 -180.0 0.66356 + 180.0 -180.0 0.98936 + -180.0 -165.0 0.96101 + -165.0 -165.0 0.37535 + -150.0 -165.0 -0.35733 + -135.0 -165.0 -0.69994 + -120.0 -165.0 -0.67298 + -105.0 -165.0 -0.58294 + -90.0 -165.0 -0.66465 + -75.0 -165.0 -1.02945 + -60.0 -165.0 -1.72427 + -45.0 -165.0 -2.19357 + -30.0 -165.0 -2.26378 + -15.0 -165.0 -1.73850 + 0.0 -165.0 -0.80969 + 15.0 -165.0 -1.16164 + 30.0 -165.0 -1.62772 + 45.0 -165.0 -1.51932 + 60.0 -165.0 -0.62569 + 75.0 -165.0 0.13130 + 90.0 -165.0 0.41019 + 105.0 -165.0 0.32974 + 120.0 -165.0 0.19191 + 135.0 -165.0 0.32320 + 150.0 -165.0 0.68257 + 165.0 -165.0 1.03015 + 180.0 -165.0 0.96101 + -180.0 -150.0 0.72651 + -165.0 -150.0 -0.04361 + -150.0 -150.0 -0.78147 + -135.0 -150.0 -0.90703 + -120.0 -150.0 -0.65095 + -105.0 -150.0 -0.48165 + -90.0 -150.0 -0.59657 + -75.0 -150.0 -1.14449 + -60.0 -150.0 -1.75396 + -45.0 -150.0 -2.27900 + -30.0 -150.0 -2.14873 + -15.0 -150.0 -0.26757 + 0.0 -150.0 -0.77578 + 15.0 -150.0 -1.30595 + 30.0 -150.0 -1.79607 + 45.0 -150.0 -1.55982 + 60.0 -150.0 -0.57905 + 75.0 -150.0 0.30576 + 90.0 -150.0 0.70711 + 105.0 -150.0 0.68903 + 120.0 -150.0 0.53594 + 135.0 -150.0 0.60304 + 150.0 -150.0 0.88805 + 165.0 -150.0 0.99720 + 180.0 -150.0 0.72651 + -180.0 -135.0 0.15500 + -165.0 -135.0 -0.20013 + -150.0 -135.0 -0.79660 + -135.0 -135.0 -0.74958 + -120.0 -135.0 -0.43624 + -105.0 -135.0 -0.36715 + -90.0 -135.0 -0.58938 + -75.0 -135.0 -0.99698 + -60.0 -135.0 -1.59208 + -45.0 -135.0 -1.67026 + -30.0 -135.0 0.50672 + -15.0 -135.0 -0.03293 + 0.0 -135.0 -0.84501 + 15.0 -135.0 -1.52731 + 30.0 -135.0 -1.89898 + 45.0 -135.0 -1.54469 + 60.0 -135.0 -0.53752 + 75.0 -135.0 0.40003 + 90.0 -135.0 0.88952 + 105.0 -135.0 0.82150 + 120.0 -135.0 0.58663 + 135.0 -135.0 0.56781 + 150.0 -135.0 0.74002 + 165.0 -135.0 0.84486 + 180.0 -135.0 0.15500 + -180.0 -120.0 0.34021 + -165.0 -120.0 -0.20306 + -150.0 -120.0 -0.62787 + -135.0 -120.0 -0.55418 + -120.0 -120.0 -0.38986 + -105.0 -120.0 -0.44533 + -90.0 -120.0 -0.60179 + -75.0 -120.0 -0.93351 + -60.0 -120.0 -1.09198 + -45.0 -120.0 -0.18408 + -30.0 -120.0 1.24545 + -15.0 -120.0 -0.24279 + 0.0 -120.0 -1.24581 + 15.0 -120.0 -1.76363 + 30.0 -120.0 -1.80810 + 45.0 -120.0 -1.40319 + 60.0 -120.0 -0.63233 + 75.0 -120.0 0.15411 + 90.0 -120.0 0.58640 + 105.0 -120.0 0.51937 + 120.0 -120.0 0.25822 + 135.0 -120.0 0.13668 + 150.0 -120.0 0.23659 + 165.0 -120.0 0.46899 + 180.0 -120.0 0.34021 + -180.0 -105.0 -0.15437 + -165.0 -105.0 -0.14060 + -150.0 -105.0 -0.54321 + -135.0 -105.0 -0.58112 + -120.0 -105.0 -0.64967 + -105.0 -105.0 -0.71916 + -90.0 -105.0 -0.78801 + -75.0 -105.0 -0.76163 + -60.0 -105.0 -0.33401 + -45.0 -105.0 0.91720 + -30.0 -105.0 0.65423 + -15.0 -105.0 -0.84456 + 0.0 -105.0 -1.63476 + 15.0 -105.0 -1.65992 + 30.0 -105.0 -1.33178 + 45.0 -105.0 -1.08999 + 60.0 -105.0 -0.74243 + 75.0 -105.0 -0.33157 + 90.0 -105.0 -0.20618 + 105.0 -105.0 -0.07103 + 120.0 -105.0 -0.25941 + 135.0 -105.0 -0.37634 + 150.0 -105.0 -0.12892 + 165.0 -105.0 0.19386 + 180.0 -105.0 -0.15437 + -180.0 -90.0 0.44630 + -165.0 -90.0 0.02406 + -150.0 -90.0 -0.42821 + -135.0 -90.0 -0.76736 + -120.0 -90.0 -0.93537 + -105.0 -90.0 -0.86621 + -90.0 -90.0 -0.66178 + -75.0 -90.0 -0.23513 + -60.0 -90.0 0.41508 + -45.0 -90.0 0.97897 + -30.0 -90.0 -0.30358 + -15.0 -90.0 -1.42025 + 0.0 -90.0 -1.62146 + 15.0 -90.0 -0.98816 + 30.0 -90.0 -0.58148 + 45.0 -90.0 -0.49791 + 60.0 -90.0 -0.32045 + 75.0 -90.0 -0.39639 + 90.0 -90.0 -0.94422 + 105.0 -90.0 -0.74539 + 120.0 -90.0 -0.60241 + 135.0 -90.0 -0.56295 + 150.0 -90.0 -0.15877 + 165.0 -90.0 0.33609 + 180.0 -90.0 0.44630 + -180.0 -75.0 0.69562 + -165.0 -75.0 0.16403 + -150.0 -75.0 -0.43627 + -135.0 -75.0 -0.79169 + -120.0 -75.0 -0.80743 + -105.0 -75.0 -0.48767 + -90.0 -75.0 0.12397 + -75.0 -75.0 0.80972 + -60.0 -75.0 0.52616 + -45.0 -75.0 -0.13884 + -30.0 -75.0 -1.08459 + -15.0 -75.0 -1.55600 + 0.0 -75.0 -1.12531 + 15.0 -75.0 -0.19831 + 30.0 -75.0 -0.00344 + 45.0 -75.0 0.01061 + 60.0 -75.0 0.11066 + 75.0 -75.0 -0.12406 + 90.0 -75.0 -0.81980 + 105.0 -75.0 -1.04369 + 120.0 -75.0 -0.62525 + 135.0 -75.0 -0.37223 + 150.0 -75.0 0.09012 + 165.0 -75.0 0.58855 + 180.0 -75.0 0.69562 + -180.0 -60.0 0.70531 + -165.0 -60.0 0.15456 + -150.0 -60.0 -0.40882 + -135.0 -60.0 -0.57653 + -120.0 -60.0 -0.20146 + -105.0 -60.0 0.21285 + -90.0 -60.0 0.15007 + -75.0 -60.0 0.06572 + -60.0 -60.0 -0.22861 + -45.0 -60.0 -0.75313 + -30.0 -60.0 -1.17725 + -15.0 -60.0 -1.07040 + 0.0 -60.0 -0.29306 + 15.0 -60.0 0.11777 + 30.0 -60.0 0.42905 + 45.0 -60.0 0.53679 + 60.0 -60.0 0.52038 + 75.0 -60.0 0.27617 + 90.0 -60.0 -0.36078 + 105.0 -60.0 -0.66569 + 120.0 -60.0 -0.35068 + 135.0 -60.0 -0.13164 + 150.0 -60.0 0.27666 + 165.0 -60.0 0.70865 + 180.0 -60.0 0.70531 + -180.0 -45.0 0.42237 + -165.0 -45.0 -0.14148 + -150.0 -45.0 -0.50856 + -135.0 -45.0 -0.14423 + -120.0 -45.0 -0.53339 + -105.0 -45.0 -0.51400 + -90.0 -45.0 -0.33290 + -75.0 -45.0 -0.24488 + -60.0 -45.0 -0.32054 + -45.0 -45.0 -0.40379 + -30.0 -45.0 -0.41006 + -15.0 -45.0 -0.23372 + 0.0 -45.0 0.07185 + 15.0 -45.0 0.70729 + 30.0 -45.0 1.16881 + 45.0 -45.0 1.23276 + 60.0 -45.0 0.77518 + 75.0 -45.0 0.51970 + 90.0 -45.0 -0.12956 + 105.0 -45.0 -0.24028 + 120.0 -45.0 -0.08791 + 135.0 -45.0 0.02315 + 150.0 -45.0 0.32774 + 165.0 -45.0 0.55330 + 180.0 -45.0 0.42237 + -180.0 -30.0 0.12700 + -165.0 -30.0 -0.36697 + -150.0 -30.0 -0.33178 + -135.0 -30.0 -1.09856 + -120.0 -30.0 -1.01098 + -105.0 -30.0 -0.61780 + -90.0 -30.0 -0.18232 + -75.0 -30.0 0.14143 + -60.0 -30.0 0.40819 + -45.0 -30.0 0.50556 + -30.0 -30.0 0.34379 + -15.0 -30.0 0.31224 + 0.0 -30.0 0.97008 + 15.0 -30.0 1.70616 + 30.0 -30.0 1.99942 + 45.0 -30.0 1.79196 + 60.0 -30.0 1.26978 + 75.0 -30.0 0.65732 + 90.0 -30.0 0.04223 + 105.0 -30.0 0.22658 + 120.0 -30.0 0.08209 + 135.0 -30.0 0.05525 + 150.0 -30.0 0.22382 + 165.0 -30.0 0.33964 + 180.0 -30.0 0.12700 + -180.0 -15.0 -0.06517 + -165.0 -15.0 -0.13598 + -150.0 -15.0 -1.30614 + -135.0 -15.0 -1.09555 + -120.0 -15.0 -0.64991 + -105.0 -15.0 -0.06482 + -90.0 -15.0 0.49509 + -75.0 -15.0 0.92103 + -60.0 -15.0 1.94755 + -45.0 -15.0 0.95164 + -30.0 -15.0 0.87870 + -15.0 -15.0 1.42479 + 0.0 -15.0 2.06338 + 15.0 -15.0 2.50243 + 30.0 -15.0 2.59266 + 45.0 -15.0 2.02131 + 60.0 -15.0 1.26236 + 75.0 -15.0 0.65759 + 90.0 -15.0 0.60601 + 105.0 -15.0 0.40777 + 120.0 -15.0 0.08605 + 135.0 -15.0 -0.02333 + 150.0 -15.0 0.06947 + 165.0 -15.0 0.13044 + 180.0 -15.0 -0.06517 + -180.0 0.0 -1.44412 + -165.0 0.0 -1.37206 + -150.0 0.0 -0.97055 + -135.0 0.0 -0.54692 + -120.0 0.0 -0.04768 + -105.0 0.0 0.65462 + -90.0 0.0 1.09803 + -75.0 0.0 1.41180 + -60.0 0.0 1.23685 + -45.0 0.0 1.32368 + -30.0 0.0 1.83555 + -15.0 0.0 2.29146 + 0.0 0.0 2.61632 + 15.0 0.0 2.73204 + 30.0 0.0 2.49607 + 45.0 0.0 1.76205 + 60.0 0.0 1.23208 + 75.0 0.0 1.11843 + 90.0 0.0 1.50389 + 105.0 0.0 0.20088 + 120.0 0.0 -0.22667 + 135.0 0.0 -0.38306 + 150.0 0.0 -0.27813 + 165.0 0.0 -0.08165 + 180.0 0.0 -1.44412 + -180.0 15.0 -1.54337 + -165.0 15.0 -0.94875 + -150.0 15.0 -0.44630 + -135.0 15.0 -0.06444 + -120.0 15.0 0.39675 + -105.0 15.0 0.90513 + -90.0 15.0 1.24019 + -75.0 15.0 1.18954 + -60.0 15.0 1.36753 + -45.0 15.0 1.82290 + -30.0 15.0 2.22229 + -15.0 15.0 2.44694 + 0.0 15.0 2.44244 + 15.0 15.0 2.26164 + 30.0 15.0 1.85516 + 45.0 15.0 1.56722 + 60.0 15.0 1.43193 + 75.0 15.0 0.71918 + 90.0 15.0 0.14053 + 105.0 15.0 -0.36429 + 120.0 15.0 -0.76466 + 135.0 15.0 -0.87217 + 150.0 15.0 -0.57197 + 165.0 15.0 -1.61569 + 180.0 15.0 -1.54337 + -180.0 30.0 -1.09485 + -165.0 30.0 -0.56681 + -150.0 30.0 -0.13387 + -135.0 30.0 0.19412 + -120.0 30.0 0.57374 + -105.0 30.0 0.86366 + -90.0 30.0 0.80314 + -75.0 30.0 1.08125 + -60.0 30.0 1.39143 + -45.0 30.0 1.86048 + -30.0 30.0 2.01491 + -15.0 30.0 2.03904 + 0.0 30.0 1.77856 + 15.0 30.0 1.48754 + 30.0 30.0 1.53762 + 45.0 30.0 1.22766 + 60.0 30.0 0.55347 + 75.0 30.0 -0.06469 + 90.0 30.0 -0.47099 + 105.0 30.0 -0.82958 + 120.0 30.0 -1.01883 + 135.0 30.0 -0.75479 + 150.0 30.0 -1.39221 + 165.0 30.0 -1.55942 + 180.0 30.0 -1.09485 + -180.0 45.0 -0.55882 + -165.0 45.0 -0.22825 + -150.0 45.0 0.01795 + -135.0 45.0 0.21896 + -120.0 45.0 0.49238 + -105.0 45.0 0.39403 + -90.0 45.0 0.48870 + -75.0 45.0 0.90318 + -60.0 45.0 1.06730 + -45.0 45.0 1.40576 + -30.0 45.0 1.50400 + -15.0 45.0 1.39328 + 0.0 45.0 1.13519 + 15.0 45.0 1.11176 + 30.0 45.0 0.55506 + 45.0 45.0 0.04408 + 60.0 45.0 -0.25930 + 75.0 45.0 -0.42888 + 90.0 45.0 -0.51963 + 105.0 45.0 -0.55634 + 120.0 45.0 -0.25212 + 135.0 45.0 -0.62098 + 150.0 45.0 -1.22694 + 165.0 45.0 -1.05054 + 180.0 45.0 -0.55882 + -180.0 60.0 -0.18285 + -165.0 60.0 -0.08650 + -150.0 60.0 0.00476 + -135.0 60.0 0.11545 + -120.0 60.0 0.16266 + -105.0 60.0 0.01161 + -90.0 60.0 0.39632 + -75.0 60.0 0.75519 + -60.0 60.0 0.96557 + -45.0 60.0 0.97640 + -30.0 60.0 0.97745 + -15.0 60.0 0.97978 + 0.0 60.0 0.79555 + 15.0 60.0 -0.15675 + 30.0 60.0 -0.51647 + 45.0 60.0 -0.39418 + 60.0 60.0 -0.15303 + 75.0 60.0 -0.00800 + 90.0 60.0 0.09982 + 105.0 60.0 0.37002 + 120.0 60.0 0.12378 + 135.0 60.0 -0.63827 + 150.0 60.0 -0.59589 + 165.0 60.0 -0.38041 + 180.0 60.0 -0.18285 + -180.0 75.0 -0.06600 + -165.0 75.0 -0.07528 + -150.0 75.0 -0.04119 + -135.0 75.0 -0.07933 + -120.0 75.0 -0.19424 + -105.0 75.0 -0.27213 + -90.0 75.0 0.00000 + -75.0 75.0 0.40627 + -60.0 75.0 0.67141 + -45.0 75.0 0.48954 + -30.0 75.0 0.49392 + -15.0 75.0 0.53926 + 0.0 75.0 -0.43613 + 15.0 75.0 -0.91296 + 30.0 75.0 -0.57046 + 45.0 75.0 0.20602 + 60.0 75.0 0.66426 + 75.0 75.0 0.78486 + 90.0 75.0 0.83638 + 105.0 75.0 0.47569 + 120.0 75.0 -0.24156 + 135.0 75.0 -0.36935 + 150.0 75.0 -0.03276 + 165.0 75.0 -0.00079 + 180.0 75.0 -0.06600 + -180.0 90.0 -0.19813 + -165.0 90.0 -0.18275 + -150.0 90.0 -0.13564 + -135.0 90.0 -0.16443 + -120.0 90.0 -0.25121 + -105.0 90.0 -0.36588 + -90.0 90.0 -0.30532 + -75.0 90.0 -0.05335 + -60.0 90.0 -0.11065 + -45.0 90.0 -0.24703 + -30.0 90.0 -0.35383 + -15.0 90.0 -0.66704 + 0.0 90.0 -1.22785 + 15.0 90.0 -0.99837 + 30.0 90.0 0.07165 + 45.0 90.0 1.17090 + 60.0 90.0 1.52568 + 75.0 90.0 1.19212 + 90.0 90.0 0.65821 + 105.0 90.0 0.07691 + 120.0 90.0 -0.25244 + 135.0 90.0 -0.10611 + 150.0 90.0 0.09358 + 165.0 90.0 0.00731 + 180.0 90.0 -0.19813 + -180.0 105.0 -0.34850 + -165.0 105.0 -0.15035 + -150.0 105.0 -0.40367 + -135.0 105.0 -0.01197 + -120.0 105.0 -0.06100 + -105.0 105.0 -0.15190 + -90.0 105.0 -0.31715 + -75.0 105.0 -0.62391 + -60.0 105.0 -0.90231 + -45.0 105.0 -1.37607 + -30.0 105.0 -1.62179 + -15.0 105.0 -1.73579 + 0.0 105.0 -1.64875 + 15.0 105.0 -0.75542 + 30.0 105.0 0.71157 + 45.0 105.0 1.26356 + 60.0 105.0 0.75960 + 75.0 105.0 0.59400 + 90.0 105.0 0.30667 + 105.0 105.0 -0.06284 + 120.0 105.0 -0.20456 + 135.0 105.0 -0.08836 + 150.0 105.0 -0.16590 + 165.0 105.0 -0.35505 + 180.0 105.0 -0.34850 + -180.0 120.0 -0.34576 + -165.0 120.0 0.02576 + -150.0 120.0 0.27228 + -135.0 120.0 0.28454 + -120.0 120.0 0.18375 + -105.0 120.0 0.01398 + -90.0 120.0 -0.27455 + -75.0 120.0 -0.77580 + -60.0 120.0 -1.42554 + -45.0 120.0 -1.99064 + -30.0 120.0 -2.37393 + -15.0 120.0 -2.20009 + 0.0 120.0 -1.60683 + 15.0 120.0 -0.44372 + 30.0 120.0 1.09513 + 45.0 120.0 0.35522 + 60.0 120.0 -0.04151 + 75.0 120.0 0.17766 + 90.0 120.0 0.14305 + 105.0 120.0 -0.13472 + 120.0 120.0 -0.31725 + 135.0 120.0 -0.45800 + 150.0 120.0 -0.64821 + 165.0 120.0 -0.63355 + 180.0 120.0 -0.34576 + -180.0 135.0 -0.08457 + -165.0 135.0 0.36013 + -150.0 135.0 0.54446 + -135.0 135.0 0.48098 + -120.0 135.0 0.27776 + -105.0 135.0 0.02335 + -90.0 135.0 -0.28766 + -75.0 135.0 -0.80414 + -60.0 135.0 -1.51330 + -45.0 135.0 -2.20028 + -30.0 135.0 -2.36835 + -15.0 135.0 -2.12483 + 0.0 135.0 -1.37600 + 15.0 135.0 -0.25291 + 30.0 135.0 0.78641 + 45.0 135.0 -0.96321 + 60.0 135.0 -0.57499 + 75.0 135.0 -0.00398 + 90.0 135.0 0.08668 + 105.0 135.0 -0.17475 + 120.0 135.0 -0.55212 + 135.0 135.0 -0.94225 + 150.0 135.0 -1.01661 + 165.0 135.0 -0.69656 + 180.0 135.0 -0.08457 + -180.0 150.0 0.28510 + -165.0 150.0 0.66185 + -150.0 150.0 0.69665 + -135.0 150.0 0.48378 + -120.0 150.0 0.16399 + -105.0 150.0 -0.09637 + -90.0 150.0 -0.36878 + -75.0 150.0 -0.80945 + -60.0 150.0 -1.41793 + -45.0 150.0 -2.18914 + -30.0 150.0 -2.20786 + -15.0 150.0 -1.82363 + 0.0 150.0 -1.11629 + 15.0 150.0 -0.04735 + 30.0 150.0 -1.17126 + 45.0 150.0 -1.34899 + 60.0 150.0 -0.62467 + 75.0 150.0 0.05642 + 90.0 150.0 0.17332 + 105.0 150.0 -0.14673 + 120.0 150.0 -0.69800 + 135.0 150.0 -1.11306 + 150.0 150.0 -1.02621 + 165.0 150.0 -0.41495 + 180.0 150.0 0.28510 + -180.0 165.0 0.76902 + -165.0 165.0 0.89311 + -150.0 165.0 0.59358 + -135.0 165.0 0.25887 + -120.0 165.0 -0.03955 + -105.0 165.0 -0.24006 + -90.0 165.0 -0.46456 + -75.0 165.0 -0.83170 + -60.0 165.0 -1.40143 + -45.0 165.0 -1.95471 + -30.0 165.0 -2.00388 + -15.0 165.0 -1.56184 + 0.0 165.0 -0.83182 + 15.0 165.0 -0.45132 + 30.0 165.0 -1.23096 + 45.0 165.0 -1.22650 + 60.0 165.0 -0.44761 + 75.0 165.0 0.25891 + 90.0 165.0 0.39936 + 105.0 165.0 0.07650 + 120.0 165.0 -0.49787 + 135.0 165.0 -0.79017 + 150.0 165.0 -0.50914 + 165.0 165.0 0.18602 + 180.0 165.0 0.76902 + -180.0 180.0 0.98936 + -165.0 180.0 0.76408 + -150.0 180.0 0.21674 + -135.0 180.0 -0.18200 + -120.0 180.0 -0.37729 + -105.0 180.0 -0.47834 + -90.0 180.0 -0.59267 + -75.0 180.0 -0.93985 + -60.0 180.0 -1.55558 + -45.0 180.0 -2.01849 + -30.0 180.0 -1.94076 + -15.0 180.0 -1.46400 + 0.0 180.0 0.18253 + 15.0 180.0 -0.80364 + 30.0 180.0 -1.32974 + 45.0 180.0 -1.31658 + 60.0 180.0 -0.50140 + 75.0 180.0 0.20431 + 90.0 180.0 0.39356 + 105.0 180.0 0.20356 + 120.0 180.0 -0.16993 + 135.0 180.0 -0.22733 + 150.0 180.0 0.13703 + 165.0 180.0 0.66356 + 180.0 180.0 0.98936 + +tortors 3 1 7 3 15 25 25 + -180.0 -180.0 0.98936 + -165.0 -180.0 0.76408 + -150.0 -180.0 0.21674 + -135.0 -180.0 -0.18200 + -120.0 -180.0 -0.37729 + -105.0 -180.0 -0.47834 + -90.0 -180.0 -0.59267 + -75.0 -180.0 -0.93985 + -60.0 -180.0 -1.55558 + -45.0 -180.0 -2.01849 + -30.0 -180.0 -1.94076 + -15.0 -180.0 -1.46400 + 0.0 -180.0 0.18253 + 15.0 -180.0 -0.80364 + 30.0 -180.0 -1.32974 + 45.0 -180.0 -1.31658 + 60.0 -180.0 -0.50140 + 75.0 -180.0 0.20431 + 90.0 -180.0 0.39356 + 105.0 -180.0 0.20356 + 120.0 -180.0 -0.16993 + 135.0 -180.0 -0.22733 + 150.0 -180.0 0.13703 + 165.0 -180.0 0.66356 + 180.0 -180.0 0.98936 + -180.0 -165.0 0.96101 + -165.0 -165.0 0.37535 + -150.0 -165.0 -0.35733 + -135.0 -165.0 -0.69994 + -120.0 -165.0 -0.67298 + -105.0 -165.0 -0.58294 + -90.0 -165.0 -0.66465 + -75.0 -165.0 -1.02945 + -60.0 -165.0 -1.72427 + -45.0 -165.0 -2.19357 + -30.0 -165.0 -2.26378 + -15.0 -165.0 -1.73850 + 0.0 -165.0 -0.80969 + 15.0 -165.0 -1.16164 + 30.0 -165.0 -1.62772 + 45.0 -165.0 -1.51932 + 60.0 -165.0 -0.62569 + 75.0 -165.0 0.13130 + 90.0 -165.0 0.41019 + 105.0 -165.0 0.32974 + 120.0 -165.0 0.19191 + 135.0 -165.0 0.32320 + 150.0 -165.0 0.68257 + 165.0 -165.0 1.03015 + 180.0 -165.0 0.96101 + -180.0 -150.0 0.72651 + -165.0 -150.0 -0.04361 + -150.0 -150.0 -0.78147 + -135.0 -150.0 -0.90703 + -120.0 -150.0 -0.65095 + -105.0 -150.0 -0.48165 + -90.0 -150.0 -0.59657 + -75.0 -150.0 -1.14449 + -60.0 -150.0 -1.75396 + -45.0 -150.0 -2.27900 + -30.0 -150.0 -2.14873 + -15.0 -150.0 -0.26757 + 0.0 -150.0 -0.77578 + 15.0 -150.0 -1.30595 + 30.0 -150.0 -1.79607 + 45.0 -150.0 -1.55982 + 60.0 -150.0 -0.57905 + 75.0 -150.0 0.30576 + 90.0 -150.0 0.70711 + 105.0 -150.0 0.68903 + 120.0 -150.0 0.53594 + 135.0 -150.0 0.60304 + 150.0 -150.0 0.88805 + 165.0 -150.0 0.99720 + 180.0 -150.0 0.72651 + -180.0 -135.0 0.15500 + -165.0 -135.0 -0.20013 + -150.0 -135.0 -0.79660 + -135.0 -135.0 -0.74958 + -120.0 -135.0 -0.43624 + -105.0 -135.0 -0.36715 + -90.0 -135.0 -0.58938 + -75.0 -135.0 -0.99698 + -60.0 -135.0 -1.59208 + -45.0 -135.0 -1.67026 + -30.0 -135.0 0.50672 + -15.0 -135.0 -0.03293 + 0.0 -135.0 -0.84501 + 15.0 -135.0 -1.52731 + 30.0 -135.0 -1.89898 + 45.0 -135.0 -1.54469 + 60.0 -135.0 -0.53752 + 75.0 -135.0 0.40003 + 90.0 -135.0 0.88952 + 105.0 -135.0 0.82150 + 120.0 -135.0 0.58663 + 135.0 -135.0 0.56781 + 150.0 -135.0 0.74002 + 165.0 -135.0 0.84486 + 180.0 -135.0 0.15500 + -180.0 -120.0 0.34021 + -165.0 -120.0 -0.20306 + -150.0 -120.0 -0.62787 + -135.0 -120.0 -0.55418 + -120.0 -120.0 -0.38986 + -105.0 -120.0 -0.44533 + -90.0 -120.0 -0.60179 + -75.0 -120.0 -0.93351 + -60.0 -120.0 -1.09198 + -45.0 -120.0 -0.18408 + -30.0 -120.0 1.24545 + -15.0 -120.0 -0.24279 + 0.0 -120.0 -1.24581 + 15.0 -120.0 -1.76363 + 30.0 -120.0 -1.80810 + 45.0 -120.0 -1.40319 + 60.0 -120.0 -0.63233 + 75.0 -120.0 0.15411 + 90.0 -120.0 0.58640 + 105.0 -120.0 0.51937 + 120.0 -120.0 0.25822 + 135.0 -120.0 0.13668 + 150.0 -120.0 0.23659 + 165.0 -120.0 0.46899 + 180.0 -120.0 0.34021 + -180.0 -105.0 -0.15437 + -165.0 -105.0 -0.14060 + -150.0 -105.0 -0.54321 + -135.0 -105.0 -0.58112 + -120.0 -105.0 -0.64967 + -105.0 -105.0 -0.71916 + -90.0 -105.0 -0.78801 + -75.0 -105.0 -0.76163 + -60.0 -105.0 -0.33401 + -45.0 -105.0 0.91720 + -30.0 -105.0 0.65423 + -15.0 -105.0 -0.84456 + 0.0 -105.0 -1.63476 + 15.0 -105.0 -1.65992 + 30.0 -105.0 -1.33178 + 45.0 -105.0 -1.08999 + 60.0 -105.0 -0.74243 + 75.0 -105.0 -0.33157 + 90.0 -105.0 -0.20618 + 105.0 -105.0 -0.07103 + 120.0 -105.0 -0.25941 + 135.0 -105.0 -0.37634 + 150.0 -105.0 -0.12892 + 165.0 -105.0 0.19386 + 180.0 -105.0 -0.15437 + -180.0 -90.0 0.44630 + -165.0 -90.0 0.02406 + -150.0 -90.0 -0.42821 + -135.0 -90.0 -0.76736 + -120.0 -90.0 -0.93537 + -105.0 -90.0 -0.86621 + -90.0 -90.0 -0.66178 + -75.0 -90.0 -0.23513 + -60.0 -90.0 0.41508 + -45.0 -90.0 0.97897 + -30.0 -90.0 -0.30358 + -15.0 -90.0 -1.42025 + 0.0 -90.0 -1.62146 + 15.0 -90.0 -0.98816 + 30.0 -90.0 -0.58148 + 45.0 -90.0 -0.49791 + 60.0 -90.0 -0.32045 + 75.0 -90.0 -0.39639 + 90.0 -90.0 -0.94422 + 105.0 -90.0 -0.74539 + 120.0 -90.0 -0.60241 + 135.0 -90.0 -0.56295 + 150.0 -90.0 -0.15877 + 165.0 -90.0 0.33609 + 180.0 -90.0 0.44630 + -180.0 -75.0 0.69562 + -165.0 -75.0 0.16403 + -150.0 -75.0 -0.43627 + -135.0 -75.0 -0.79169 + -120.0 -75.0 -0.80743 + -105.0 -75.0 -0.48767 + -90.0 -75.0 0.12397 + -75.0 -75.0 0.80972 + -60.0 -75.0 0.52616 + -45.0 -75.0 -0.13884 + -30.0 -75.0 -1.08459 + -15.0 -75.0 -1.55600 + 0.0 -75.0 -1.12531 + 15.0 -75.0 -0.19831 + 30.0 -75.0 -0.00344 + 45.0 -75.0 0.01061 + 60.0 -75.0 0.11066 + 75.0 -75.0 -0.12406 + 90.0 -75.0 -0.81980 + 105.0 -75.0 -1.04369 + 120.0 -75.0 -0.62525 + 135.0 -75.0 -0.37223 + 150.0 -75.0 0.09012 + 165.0 -75.0 0.58855 + 180.0 -75.0 0.69562 + -180.0 -60.0 0.70531 + -165.0 -60.0 0.15456 + -150.0 -60.0 -0.40882 + -135.0 -60.0 -0.57653 + -120.0 -60.0 -0.20146 + -105.0 -60.0 0.21285 + -90.0 -60.0 0.15007 + -75.0 -60.0 0.06572 + -60.0 -60.0 -0.22861 + -45.0 -60.0 -0.75313 + -30.0 -60.0 -1.17725 + -15.0 -60.0 -1.07040 + 0.0 -60.0 -0.29306 + 15.0 -60.0 0.11777 + 30.0 -60.0 0.42905 + 45.0 -60.0 0.53679 + 60.0 -60.0 0.52038 + 75.0 -60.0 0.27617 + 90.0 -60.0 -0.36078 + 105.0 -60.0 -0.66569 + 120.0 -60.0 -0.35068 + 135.0 -60.0 -0.13164 + 150.0 -60.0 0.27666 + 165.0 -60.0 0.70865 + 180.0 -60.0 0.70531 + -180.0 -45.0 0.42237 + -165.0 -45.0 -0.14148 + -150.0 -45.0 -0.50856 + -135.0 -45.0 -0.14423 + -120.0 -45.0 -0.53339 + -105.0 -45.0 -0.51400 + -90.0 -45.0 -0.33290 + -75.0 -45.0 -0.24488 + -60.0 -45.0 -0.32054 + -45.0 -45.0 -0.40379 + -30.0 -45.0 -0.41006 + -15.0 -45.0 -0.23372 + 0.0 -45.0 0.07185 + 15.0 -45.0 0.70729 + 30.0 -45.0 1.16881 + 45.0 -45.0 1.23276 + 60.0 -45.0 0.77518 + 75.0 -45.0 0.51970 + 90.0 -45.0 -0.12956 + 105.0 -45.0 -0.24028 + 120.0 -45.0 -0.08791 + 135.0 -45.0 0.02315 + 150.0 -45.0 0.32774 + 165.0 -45.0 0.55330 + 180.0 -45.0 0.42237 + -180.0 -30.0 0.12700 + -165.0 -30.0 -0.36697 + -150.0 -30.0 -0.33178 + -135.0 -30.0 -1.09856 + -120.0 -30.0 -1.01098 + -105.0 -30.0 -0.61780 + -90.0 -30.0 -0.18232 + -75.0 -30.0 0.14143 + -60.0 -30.0 0.40819 + -45.0 -30.0 0.50556 + -30.0 -30.0 0.34379 + -15.0 -30.0 0.31224 + 0.0 -30.0 0.97008 + 15.0 -30.0 1.70616 + 30.0 -30.0 1.99942 + 45.0 -30.0 1.79196 + 60.0 -30.0 1.26978 + 75.0 -30.0 0.65732 + 90.0 -30.0 0.04223 + 105.0 -30.0 0.22658 + 120.0 -30.0 0.08209 + 135.0 -30.0 0.05525 + 150.0 -30.0 0.22382 + 165.0 -30.0 0.33964 + 180.0 -30.0 0.12700 + -180.0 -15.0 -0.06517 + -165.0 -15.0 -0.13598 + -150.0 -15.0 -1.30614 + -135.0 -15.0 -1.09555 + -120.0 -15.0 -0.64991 + -105.0 -15.0 -0.06482 + -90.0 -15.0 0.49509 + -75.0 -15.0 0.92103 + -60.0 -15.0 1.94755 + -45.0 -15.0 0.95164 + -30.0 -15.0 0.87870 + -15.0 -15.0 1.42479 + 0.0 -15.0 2.06338 + 15.0 -15.0 2.50243 + 30.0 -15.0 2.59266 + 45.0 -15.0 2.02131 + 60.0 -15.0 1.26236 + 75.0 -15.0 0.65759 + 90.0 -15.0 0.60601 + 105.0 -15.0 0.40777 + 120.0 -15.0 0.08605 + 135.0 -15.0 -0.02333 + 150.0 -15.0 0.06947 + 165.0 -15.0 0.13044 + 180.0 -15.0 -0.06517 + -180.0 0.0 -1.44412 + -165.0 0.0 -1.37206 + -150.0 0.0 -0.97055 + -135.0 0.0 -0.54692 + -120.0 0.0 -0.04768 + -105.0 0.0 0.65462 + -90.0 0.0 1.09803 + -75.0 0.0 1.41180 + -60.0 0.0 1.23685 + -45.0 0.0 1.32368 + -30.0 0.0 1.83555 + -15.0 0.0 2.29146 + 0.0 0.0 2.61632 + 15.0 0.0 2.73204 + 30.0 0.0 2.49607 + 45.0 0.0 1.76205 + 60.0 0.0 1.23208 + 75.0 0.0 1.11843 + 90.0 0.0 1.50389 + 105.0 0.0 0.20088 + 120.0 0.0 -0.22667 + 135.0 0.0 -0.38306 + 150.0 0.0 -0.27813 + 165.0 0.0 -0.08165 + 180.0 0.0 -1.44412 + -180.0 15.0 -1.54337 + -165.0 15.0 -0.94875 + -150.0 15.0 -0.44630 + -135.0 15.0 -0.06444 + -120.0 15.0 0.39675 + -105.0 15.0 0.90513 + -90.0 15.0 1.24019 + -75.0 15.0 1.18954 + -60.0 15.0 1.36753 + -45.0 15.0 1.82290 + -30.0 15.0 2.22229 + -15.0 15.0 2.44694 + 0.0 15.0 2.44244 + 15.0 15.0 2.26164 + 30.0 15.0 1.85516 + 45.0 15.0 1.56722 + 60.0 15.0 1.43193 + 75.0 15.0 0.71918 + 90.0 15.0 0.14053 + 105.0 15.0 -0.36429 + 120.0 15.0 -0.76466 + 135.0 15.0 -0.87217 + 150.0 15.0 -0.57197 + 165.0 15.0 -1.61569 + 180.0 15.0 -1.54337 + -180.0 30.0 -1.09485 + -165.0 30.0 -0.56681 + -150.0 30.0 -0.13387 + -135.0 30.0 0.19412 + -120.0 30.0 0.57374 + -105.0 30.0 0.86366 + -90.0 30.0 0.80314 + -75.0 30.0 1.08125 + -60.0 30.0 1.39143 + -45.0 30.0 1.86048 + -30.0 30.0 2.01491 + -15.0 30.0 2.03904 + 0.0 30.0 1.77856 + 15.0 30.0 1.48754 + 30.0 30.0 1.53762 + 45.0 30.0 1.22766 + 60.0 30.0 0.55347 + 75.0 30.0 -0.06469 + 90.0 30.0 -0.47099 + 105.0 30.0 -0.82958 + 120.0 30.0 -1.01883 + 135.0 30.0 -0.75479 + 150.0 30.0 -1.39221 + 165.0 30.0 -1.55942 + 180.0 30.0 -1.09485 + -180.0 45.0 -0.55882 + -165.0 45.0 -0.22825 + -150.0 45.0 0.01795 + -135.0 45.0 0.21896 + -120.0 45.0 0.49238 + -105.0 45.0 0.39403 + -90.0 45.0 0.48870 + -75.0 45.0 0.90318 + -60.0 45.0 1.06730 + -45.0 45.0 1.40576 + -30.0 45.0 1.50400 + -15.0 45.0 1.39328 + 0.0 45.0 1.13519 + 15.0 45.0 1.11176 + 30.0 45.0 0.55506 + 45.0 45.0 0.04408 + 60.0 45.0 -0.25930 + 75.0 45.0 -0.42888 + 90.0 45.0 -0.51963 + 105.0 45.0 -0.55634 + 120.0 45.0 -0.25212 + 135.0 45.0 -0.62098 + 150.0 45.0 -1.22694 + 165.0 45.0 -1.05054 + 180.0 45.0 -0.55882 + -180.0 60.0 -0.18285 + -165.0 60.0 -0.08650 + -150.0 60.0 0.00476 + -135.0 60.0 0.11545 + -120.0 60.0 0.16266 + -105.0 60.0 0.01161 + -90.0 60.0 0.39632 + -75.0 60.0 0.75519 + -60.0 60.0 0.96557 + -45.0 60.0 0.97640 + -30.0 60.0 0.97745 + -15.0 60.0 0.97978 + 0.0 60.0 0.79555 + 15.0 60.0 -0.15675 + 30.0 60.0 -0.51647 + 45.0 60.0 -0.39418 + 60.0 60.0 -0.15303 + 75.0 60.0 -0.00800 + 90.0 60.0 0.09982 + 105.0 60.0 0.37002 + 120.0 60.0 0.12378 + 135.0 60.0 -0.63827 + 150.0 60.0 -0.59589 + 165.0 60.0 -0.38041 + 180.0 60.0 -0.18285 + -180.0 75.0 -0.06600 + -165.0 75.0 -0.07528 + -150.0 75.0 -0.04119 + -135.0 75.0 -0.07933 + -120.0 75.0 -0.19424 + -105.0 75.0 -0.27213 + -90.0 75.0 0.00000 + -75.0 75.0 0.40627 + -60.0 75.0 0.67141 + -45.0 75.0 0.48954 + -30.0 75.0 0.49392 + -15.0 75.0 0.53926 + 0.0 75.0 -0.43613 + 15.0 75.0 -0.91296 + 30.0 75.0 -0.57046 + 45.0 75.0 0.20602 + 60.0 75.0 0.66426 + 75.0 75.0 0.78486 + 90.0 75.0 0.83638 + 105.0 75.0 0.47569 + 120.0 75.0 -0.24156 + 135.0 75.0 -0.36935 + 150.0 75.0 -0.03276 + 165.0 75.0 -0.00079 + 180.0 75.0 -0.06600 + -180.0 90.0 -0.19813 + -165.0 90.0 -0.18275 + -150.0 90.0 -0.13564 + -135.0 90.0 -0.16443 + -120.0 90.0 -0.25121 + -105.0 90.0 -0.36588 + -90.0 90.0 -0.30532 + -75.0 90.0 -0.05335 + -60.0 90.0 -0.11065 + -45.0 90.0 -0.24703 + -30.0 90.0 -0.35383 + -15.0 90.0 -0.66704 + 0.0 90.0 -1.22785 + 15.0 90.0 -0.99837 + 30.0 90.0 0.07165 + 45.0 90.0 1.17090 + 60.0 90.0 1.52568 + 75.0 90.0 1.19212 + 90.0 90.0 0.65821 + 105.0 90.0 0.07691 + 120.0 90.0 -0.25244 + 135.0 90.0 -0.10611 + 150.0 90.0 0.09358 + 165.0 90.0 0.00731 + 180.0 90.0 -0.19813 + -180.0 105.0 -0.34850 + -165.0 105.0 -0.15035 + -150.0 105.0 -0.40367 + -135.0 105.0 -0.01197 + -120.0 105.0 -0.06100 + -105.0 105.0 -0.15190 + -90.0 105.0 -0.31715 + -75.0 105.0 -0.62391 + -60.0 105.0 -0.90231 + -45.0 105.0 -1.37607 + -30.0 105.0 -1.62179 + -15.0 105.0 -1.73579 + 0.0 105.0 -1.64875 + 15.0 105.0 -0.75542 + 30.0 105.0 0.71157 + 45.0 105.0 1.26356 + 60.0 105.0 0.75960 + 75.0 105.0 0.59400 + 90.0 105.0 0.30667 + 105.0 105.0 -0.06284 + 120.0 105.0 -0.20456 + 135.0 105.0 -0.08836 + 150.0 105.0 -0.16590 + 165.0 105.0 -0.35505 + 180.0 105.0 -0.34850 + -180.0 120.0 -0.34576 + -165.0 120.0 0.02576 + -150.0 120.0 0.27228 + -135.0 120.0 0.28454 + -120.0 120.0 0.18375 + -105.0 120.0 0.01398 + -90.0 120.0 -0.27455 + -75.0 120.0 -0.77580 + -60.0 120.0 -1.42554 + -45.0 120.0 -1.99064 + -30.0 120.0 -2.37393 + -15.0 120.0 -2.20009 + 0.0 120.0 -1.60683 + 15.0 120.0 -0.44372 + 30.0 120.0 1.09513 + 45.0 120.0 0.35522 + 60.0 120.0 -0.04151 + 75.0 120.0 0.17766 + 90.0 120.0 0.14305 + 105.0 120.0 -0.13472 + 120.0 120.0 -0.31725 + 135.0 120.0 -0.45800 + 150.0 120.0 -0.64821 + 165.0 120.0 -0.63355 + 180.0 120.0 -0.34576 + -180.0 135.0 -0.08457 + -165.0 135.0 0.36013 + -150.0 135.0 0.54446 + -135.0 135.0 0.48098 + -120.0 135.0 0.27776 + -105.0 135.0 0.02335 + -90.0 135.0 -0.28766 + -75.0 135.0 -0.80414 + -60.0 135.0 -1.51330 + -45.0 135.0 -2.20028 + -30.0 135.0 -2.36835 + -15.0 135.0 -2.12483 + 0.0 135.0 -1.37600 + 15.0 135.0 -0.25291 + 30.0 135.0 0.78641 + 45.0 135.0 -0.96321 + 60.0 135.0 -0.57499 + 75.0 135.0 -0.00398 + 90.0 135.0 0.08668 + 105.0 135.0 -0.17475 + 120.0 135.0 -0.55212 + 135.0 135.0 -0.94225 + 150.0 135.0 -1.01661 + 165.0 135.0 -0.69656 + 180.0 135.0 -0.08457 + -180.0 150.0 0.28510 + -165.0 150.0 0.66185 + -150.0 150.0 0.69665 + -135.0 150.0 0.48378 + -120.0 150.0 0.16399 + -105.0 150.0 -0.09637 + -90.0 150.0 -0.36878 + -75.0 150.0 -0.80945 + -60.0 150.0 -1.41793 + -45.0 150.0 -2.18914 + -30.0 150.0 -2.20786 + -15.0 150.0 -1.82363 + 0.0 150.0 -1.11629 + 15.0 150.0 -0.04735 + 30.0 150.0 -1.17126 + 45.0 150.0 -1.34899 + 60.0 150.0 -0.62467 + 75.0 150.0 0.05642 + 90.0 150.0 0.17332 + 105.0 150.0 -0.14673 + 120.0 150.0 -0.69800 + 135.0 150.0 -1.11306 + 150.0 150.0 -1.02621 + 165.0 150.0 -0.41495 + 180.0 150.0 0.28510 + -180.0 165.0 0.76902 + -165.0 165.0 0.89311 + -150.0 165.0 0.59358 + -135.0 165.0 0.25887 + -120.0 165.0 -0.03955 + -105.0 165.0 -0.24006 + -90.0 165.0 -0.46456 + -75.0 165.0 -0.83170 + -60.0 165.0 -1.40143 + -45.0 165.0 -1.95471 + -30.0 165.0 -2.00388 + -15.0 165.0 -1.56184 + 0.0 165.0 -0.83182 + 15.0 165.0 -0.45132 + 30.0 165.0 -1.23096 + 45.0 165.0 -1.22650 + 60.0 165.0 -0.44761 + 75.0 165.0 0.25891 + 90.0 165.0 0.39936 + 105.0 165.0 0.07650 + 120.0 165.0 -0.49787 + 135.0 165.0 -0.79017 + 150.0 165.0 -0.50914 + 165.0 165.0 0.18602 + 180.0 165.0 0.76902 + -180.0 180.0 0.98936 + -165.0 180.0 0.76408 + -150.0 180.0 0.21674 + -135.0 180.0 -0.18200 + -120.0 180.0 -0.37729 + -105.0 180.0 -0.47834 + -90.0 180.0 -0.59267 + -75.0 180.0 -0.93985 + -60.0 180.0 -1.55558 + -45.0 180.0 -2.01849 + -30.0 180.0 -1.94076 + -15.0 180.0 -1.46400 + 0.0 180.0 0.18253 + 15.0 180.0 -0.80364 + 30.0 180.0 -1.32974 + 45.0 180.0 -1.31658 + 60.0 180.0 -0.50140 + 75.0 180.0 0.20431 + 90.0 180.0 0.39356 + 105.0 180.0 0.20356 + 120.0 180.0 -0.16993 + 135.0 180.0 -0.22733 + 150.0 180.0 0.13703 + 165.0 180.0 0.66356 + 180.0 180.0 0.98936 + +tortors 63 63 62 63 63 25 25 + -60.0 -60.0 0.00000 + -55.0 -60.0 0.00000 + -50.0 -60.0 0.00000 + -45.0 -60.0 0.00000 + -40.0 -60.0 0.00000 + -35.0 -60.0 0.00000 + -30.0 -60.0 0.00000 + -25.0 -60.0 0.00000 + -20.0 -60.0 0.00000 + -15.0 -60.0 0.00000 + -10.0 -60.0 0.00000 + -5.0 -60.0 0.00000 + 0.0 -60.0 0.00000 + 5.0 -60.0 0.00000 + 10.0 -60.0 0.00000 + 15.0 -60.0 0.00000 + 20.0 -60.0 0.00000 + 25.0 -60.0 -3.34859 + 30.0 -60.0 -2.26068 + 35.0 -60.0 -1.53407 + 40.0 -60.0 -0.92165 + 45.0 -60.0 -0.49220 + 50.0 -60.0 -0.49945 + 55.0 -60.0 -1.22214 + 60.0 -60.0 -2.71591 + -60.0 -55.0 0.00000 + -55.0 -55.0 0.00000 + -50.0 -55.0 0.00000 + -45.0 -55.0 0.00000 + -40.0 -55.0 0.00000 + -35.0 -55.0 0.00000 + -30.0 -55.0 0.00000 + -25.0 -55.0 0.00000 + -20.0 -55.0 0.00000 + -15.0 -55.0 0.00000 + -10.0 -55.0 0.00000 + -5.0 -55.0 0.00000 + 0.0 -55.0 0.00000 + 5.0 -55.0 0.00000 + 10.0 -55.0 0.00000 + 15.0 -55.0 -4.30948 + 20.0 -55.0 -2.57230 + 25.0 -55.0 -1.54795 + 30.0 -55.0 -0.77830 + 35.0 -55.0 -0.10949 + 40.0 -55.0 0.39671 + 45.0 -55.0 0.53940 + 50.0 -55.0 -0.01316 + 55.0 -55.0 -1.35124 + 60.0 -55.0 -2.97925 + -60.0 -50.0 0.00000 + -55.0 -50.0 0.00000 + -50.0 -50.0 0.00000 + -45.0 -50.0 0.00000 + -40.0 -50.0 0.00000 + -35.0 -50.0 0.00000 + -30.0 -50.0 0.00000 + -25.0 -50.0 0.00000 + -20.0 -50.0 0.00000 + -15.0 -50.0 0.00000 + -10.0 -50.0 0.00000 + -5.0 -50.0 0.00000 + 0.0 -50.0 0.00000 + 5.0 -50.0 0.00000 + 10.0 -50.0 -3.79718 + 15.0 -50.0 -1.97217 + 20.0 -50.0 -0.90646 + 25.0 -50.0 -0.17368 + 30.0 -50.0 0.48245 + 35.0 -50.0 1.04559 + 40.0 -50.0 1.29297 + 45.0 -50.0 0.88381 + 50.0 -50.0 -0.27960 + 55.0 -50.0 -1.71413 + 60.0 -50.0 -3.29794 + -60.0 -45.0 0.00000 + -55.0 -45.0 0.00000 + -50.0 -45.0 0.00000 + -45.0 -45.0 0.00000 + -40.0 -45.0 0.00000 + -35.0 -45.0 0.00000 + -30.0 -45.0 0.00000 + -25.0 -45.0 0.00000 + -20.0 -45.0 0.00000 + -15.0 -45.0 0.00000 + -10.0 -45.0 0.00000 + -5.0 -45.0 0.00000 + 0.0 -45.0 0.00000 + 5.0 -45.0 -3.42407 + 10.0 -45.0 -1.52802 + 15.0 -45.0 -0.42681 + 20.0 -45.0 0.26477 + 25.0 -45.0 0.88153 + 30.0 -45.0 1.45874 + 35.0 -45.0 1.76987 + 40.0 -45.0 1.48943 + 45.0 -45.0 0.52323 + 50.0 -45.0 -0.70927 + 55.0 -45.0 -2.13253 + 60.0 -45.0 -3.72232 + -60.0 -40.0 0.00000 + -55.0 -40.0 0.00000 + -50.0 -40.0 0.00000 + -45.0 -40.0 0.00000 + -40.0 -40.0 0.00000 + -35.0 -40.0 0.00000 + -30.0 -40.0 0.00000 + -25.0 -40.0 0.00000 + -20.0 -40.0 0.00000 + -15.0 -40.0 0.00000 + -10.0 -40.0 0.00000 + -5.0 -40.0 0.00000 + 0.0 -40.0 -3.24603 + 5.0 -40.0 -1.26715 + 10.0 -40.0 -0.14889 + 15.0 -40.0 0.51208 + 20.0 -40.0 1.09333 + 25.0 -40.0 1.64762 + 30.0 -40.0 1.97750 + 35.0 -40.0 1.82364 + 40.0 -40.0 1.08565 + 45.0 -40.0 0.05579 + 50.0 -40.0 -1.20397 + 55.0 -40.0 -2.66579 + 60.0 -40.0 -4.29092 + -60.0 -35.0 0.00000 + -55.0 -35.0 0.00000 + -50.0 -35.0 0.00000 + -45.0 -35.0 0.00000 + -40.0 -35.0 0.00000 + -35.0 -35.0 0.00000 + -30.0 -35.0 0.00000 + -25.0 -35.0 0.00000 + -20.0 -35.0 0.00000 + -15.0 -35.0 0.00000 + -10.0 -35.0 0.00000 + -5.0 -35.0 -3.08944 + 0.0 -35.0 -1.18260 + 5.0 -35.0 -0.02491 + 10.0 -35.0 0.61137 + 15.0 -35.0 1.13349 + 20.0 -35.0 1.61794 + 25.0 -35.0 1.93538 + 30.0 -35.0 1.91657 + 35.0 -35.0 1.42337 + 40.0 -35.0 0.58960 + 45.0 -35.0 -0.50117 + 50.0 -35.0 -1.82047 + 55.0 -35.0 -3.32126 + 60.0 -35.0 -4.90932 + -60.0 -30.0 0.00000 + -55.0 -30.0 0.00000 + -50.0 -30.0 0.00000 + -45.0 -30.0 0.00000 + -40.0 -30.0 0.00000 + -35.0 -30.0 0.00000 + -30.0 -30.0 0.00000 + -25.0 -30.0 0.00000 + -20.0 -30.0 0.00000 + -15.0 -30.0 0.00000 + -10.0 -30.0 -2.95295 + -5.0 -30.0 -1.27250 + 0.0 -30.0 -0.10126 + 5.0 -30.0 0.57183 + 10.0 -30.0 1.01801 + 15.0 -30.0 1.40532 + 20.0 -30.0 1.69566 + 25.0 -30.0 1.81393 + 30.0 -30.0 1.55808 + 35.0 -30.0 0.90930 + 40.0 -30.0 -0.01572 + 45.0 -30.0 -1.18916 + 50.0 -30.0 -2.57344 + 55.0 -30.0 -4.04453 + 60.0 -30.0 -5.68632 + -60.0 -25.0 0.00000 + -55.0 -25.0 0.00000 + -50.0 -25.0 0.00000 + -45.0 -25.0 0.00000 + -40.0 -25.0 0.00000 + -35.0 -25.0 0.00000 + -30.0 -25.0 0.00000 + -25.0 -25.0 0.00000 + -20.0 -25.0 0.00000 + -15.0 -25.0 -3.24428 + -10.0 -25.0 -1.23106 + -5.0 -25.0 -0.09312 + 0.0 -25.0 0.56793 + 5.0 -25.0 0.93977 + 10.0 -25.0 1.20683 + 15.0 -25.0 1.40698 + 20.0 -25.0 1.56183 + 25.0 -25.0 1.51817 + 30.0 -25.0 1.03831 + 35.0 -25.0 0.27611 + 40.0 -25.0 -0.75741 + 45.0 -25.0 -2.04455 + 50.0 -25.0 -3.41908 + 55.0 -25.0 -4.97509 + 60.0 -25.0 -6.85322 + -60.0 -20.0 0.00000 + -55.0 -20.0 0.00000 + -50.0 -20.0 0.00000 + -45.0 -20.0 0.00000 + -40.0 -20.0 0.00000 + -35.0 -20.0 0.00000 + -30.0 -20.0 0.00000 + -25.0 -20.0 0.00000 + -20.0 -20.0 -3.39739 + -15.0 -20.0 -1.38908 + -10.0 -20.0 -0.21578 + -5.0 -20.0 0.42795 + 0.0 -20.0 0.77706 + 5.0 -20.0 0.98671 + 10.0 -20.0 1.12783 + 15.0 -20.0 1.18291 + 20.0 -20.0 0.97599 + 25.0 -20.0 1.00362 + 30.0 -20.0 0.39932 + 35.0 -20.0 -0.50020 + 40.0 -20.0 -1.77572 + 45.0 -20.0 -3.10096 + 50.0 -20.0 -4.53696 + 55.0 -20.0 -6.29879 + 60.0 -20.0 0.00000 + -60.0 -15.0 0.00000 + -55.0 -15.0 0.00000 + -50.0 -15.0 0.00000 + -45.0 -15.0 0.00000 + -40.0 -15.0 0.00000 + -35.0 -15.0 0.00000 + -30.0 -15.0 0.00000 + -25.0 -15.0 -3.72204 + -20.0 -15.0 -1.66846 + -15.0 -15.0 -0.52208 + -10.0 -15.0 0.14216 + -5.0 -15.0 0.49336 + 0.0 -15.0 0.66840 + 5.0 -15.0 0.78452 + 10.0 -15.0 0.86470 + 15.0 -15.0 0.69961 + 20.0 -15.0 0.23499 + 25.0 -15.0 -0.41158 + 30.0 -15.0 -0.52970 + 35.0 -15.0 -1.86320 + 40.0 -15.0 -3.12136 + 45.0 -15.0 -4.43654 + 50.0 -15.0 -5.97830 + 55.0 -15.0 0.00000 + 60.0 -15.0 0.00000 + -60.0 -10.0 0.00000 + -55.0 -10.0 0.00000 + -50.0 -10.0 0.00000 + -45.0 -10.0 0.00000 + -40.0 -10.0 0.00000 + -35.0 -10.0 0.00000 + -30.0 -10.0 -4.15599 + -25.0 -10.0 -2.19827 + -20.0 -10.0 -0.95521 + -15.0 -10.0 -0.29886 + -10.0 -10.0 0.04835 + -5.0 -10.0 0.19772 + 0.0 -10.0 0.32406 + 5.0 -10.0 0.47801 + 10.0 -10.0 0.40841 + 15.0 -10.0 -0.01555 + 20.0 -10.0 -0.63176 + 25.0 -10.0 -1.41232 + 30.0 -10.0 -2.36589 + 35.0 -10.0 -3.31048 + 40.0 -10.0 -4.51036 + 45.0 -10.0 -5.93757 + 50.0 -10.0 0.00000 + 55.0 -10.0 0.00000 + 60.0 -10.0 0.00000 + -60.0 -5.0 0.00000 + -55.0 -5.0 0.00000 + -50.0 -5.0 0.00000 + -45.0 -5.0 0.00000 + -40.0 -5.0 0.00000 + -35.0 -5.0 -4.68511 + -30.0 -5.0 -2.85637 + -25.0 -5.0 -1.57291 + -20.0 -5.0 -0.89665 + -15.0 -5.0 -0.56005 + -10.0 -5.0 -0.41701 + -5.0 -5.0 -0.26301 + 0.0 -5.0 -0.00331 + 5.0 -5.0 0.07696 + 10.0 -5.0 -0.26667 + 15.0 -5.0 -0.83182 + 20.0 -5.0 -1.56030 + 25.0 -5.0 -2.45388 + 30.0 -5.0 -3.34910 + 35.0 -5.0 -4.42998 + 40.0 -5.0 -2.41122 + 45.0 -5.0 -7.92471 + 50.0 -5.0 0.00000 + 55.0 -5.0 0.00000 + 60.0 -5.0 0.00000 + -60.0 0.0 0.00000 + -55.0 0.0 0.00000 + -50.0 0.0 0.00000 + -45.0 0.0 0.00000 + -40.0 0.0 -5.26098 + -35.0 0.0 -3.48850 + -30.0 0.0 -2.32185 + -25.0 0.0 -1.62944 + -20.0 0.0 -1.27900 + -15.0 0.0 -1.12183 + -10.0 0.0 -0.93084 + -5.0 0.0 -0.56989 + 0.0 0.0 -0.31089 + 5.0 0.0 -0.53327 + 10.0 0.0 -1.03036 + 15.0 0.0 -1.69852 + 20.0 0.0 -2.52324 + 25.0 0.0 -3.36820 + 30.0 0.0 -4.40522 + 35.0 0.0 -2.35864 + 40.0 0.0 -5.07138 + 45.0 0.0 0.00000 + 50.0 0.0 0.00000 + 55.0 0.0 0.00000 + 60.0 0.0 0.00000 + -60.0 5.0 0.00000 + -55.0 5.0 0.00000 + -50.0 5.0 0.00000 + -45.0 5.0 0.00000 + -40.0 5.0 -4.14344 + -35.0 5.0 -3.09499 + -30.0 5.0 -2.40013 + -25.0 5.0 -2.03320 + -20.0 5.0 -1.85135 + -15.0 5.0 -1.62104 + -10.0 5.0 -1.18282 + -5.0 5.0 -0.75884 + 0.0 5.0 -0.82361 + 5.0 5.0 -1.23036 + 10.0 5.0 -1.82587 + 15.0 5.0 -2.57116 + 20.0 5.0 -3.35863 + 25.0 5.0 -4.34873 + 30.0 5.0 -2.27690 + 35.0 5.0 -4.94540 + 40.0 5.0 0.00000 + 45.0 5.0 0.00000 + 50.0 5.0 0.00000 + 55.0 5.0 0.00000 + 60.0 5.0 0.00000 + -60.0 10.0 0.00000 + -55.0 10.0 0.00000 + -50.0 10.0 0.00000 + -45.0 10.0 -4.88968 + -40.0 10.0 -3.77891 + -35.0 10.0 -3.10077 + -30.0 10.0 -2.72681 + -25.0 10.0 -2.53361 + -20.0 10.0 -2.28064 + -15.0 10.0 -1.79659 + -10.0 10.0 -1.25103 + -5.0 10.0 -1.14661 + 0.0 10.0 -1.43321 + 5.0 10.0 -1.93533 + 10.0 10.0 -2.58448 + 15.0 10.0 -3.30471 + 20.0 10.0 -0.28036 + 25.0 10.0 -5.48737 + 30.0 10.0 -7.45892 + 35.0 10.0 0.00000 + 40.0 10.0 0.00000 + 45.0 10.0 0.00000 + 50.0 10.0 0.00000 + 55.0 10.0 0.00000 + 60.0 10.0 0.00000 + -60.0 15.0 0.00000 + -55.0 15.0 0.00000 + -50.0 15.0 -5.57433 + -45.0 15.0 -4.41509 + -40.0 15.0 -3.70103 + -35.0 15.0 -3.30510 + -30.0 15.0 -3.09660 + -25.0 15.0 -2.84923 + -20.0 15.0 -2.36398 + -15.0 15.0 -1.75415 + -10.0 15.0 -1.50903 + -5.0 15.0 -1.65094 + 0.0 15.0 -2.02015 + 5.0 15.0 -2.54540 + 10.0 15.0 -3.18641 + 15.0 15.0 -0.12952 + 20.0 15.0 -1.92781 + 25.0 15.0 -4.43234 + 30.0 15.0 0.00000 + 35.0 15.0 0.00000 + 40.0 15.0 0.00000 + 45.0 15.0 0.00000 + 50.0 15.0 0.00000 + 55.0 15.0 0.00000 + 60.0 15.0 0.00000 + -60.0 20.0 0.00000 + -55.0 20.0 -6.25248 + -50.0 20.0 -5.04739 + -45.0 20.0 -4.27015 + -40.0 20.0 -3.79542 + -35.0 20.0 -3.52883 + -30.0 20.0 -3.26178 + -25.0 20.0 -2.81849 + -20.0 20.0 -2.22194 + -15.0 20.0 -1.89680 + -10.0 20.0 -1.90620 + -5.0 20.0 -2.10099 + 0.0 20.0 -2.45540 + 5.0 20.0 -2.98466 + 10.0 20.0 0.11443 + 15.0 20.0 -1.60577 + 20.0 20.0 -3.99976 + 25.0 20.0 0.00000 + 30.0 20.0 0.00000 + 35.0 20.0 0.00000 + 40.0 20.0 0.00000 + 45.0 20.0 0.00000 + 50.0 20.0 0.00000 + 55.0 20.0 0.00000 + 60.0 20.0 0.00000 + -60.0 25.0 0.00000 + -55.0 25.0 -5.82910 + -50.0 25.0 -4.85579 + -45.0 25.0 -4.24949 + -40.0 25.0 -3.86515 + -35.0 25.0 -3.52521 + -30.0 25.0 -3.09604 + -25.0 25.0 -2.54420 + -20.0 25.0 -2.22885 + -15.0 25.0 -2.17858 + -10.0 25.0 -2.22411 + -5.0 25.0 -2.36938 + 0.0 25.0 -2.73017 + 5.0 25.0 0.45724 + 10.0 25.0 -1.14103 + 15.0 25.0 -3.40622 + 20.0 25.0 0.00000 + 25.0 25.0 0.00000 + 30.0 25.0 0.00000 + 35.0 25.0 0.00000 + 40.0 25.0 0.00000 + 45.0 25.0 0.00000 + 50.0 25.0 0.00000 + 55.0 25.0 0.00000 + 60.0 25.0 0.00000 + -60.0 30.0 -6.74017 + -55.0 30.0 -5.56466 + -50.0 30.0 -4.73062 + -45.0 30.0 -4.15541 + -40.0 30.0 -3.67057 + -35.0 30.0 -3.16852 + -30.0 30.0 -2.58625 + -25.0 30.0 -2.28139 + -20.0 30.0 -2.27420 + -15.0 30.0 -2.31495 + -10.0 30.0 -2.34007 + -5.0 30.0 -2.52274 + 0.0 30.0 0.83818 + 5.0 30.0 -0.55413 + 10.0 30.0 0.00000 + 15.0 30.0 0.00000 + 20.0 30.0 0.00000 + 25.0 30.0 0.00000 + 30.0 30.0 0.00000 + 35.0 30.0 0.00000 + 40.0 30.0 0.00000 + 45.0 30.0 0.00000 + 50.0 30.0 0.00000 + 55.0 30.0 0.00000 + 60.0 30.0 0.00000 + -60.0 35.0 -6.44220 + -55.0 35.0 -5.34031 + -50.0 35.0 -4.49506 + -45.0 35.0 -3.78373 + -40.0 35.0 -3.08459 + -35.0 35.0 -2.38223 + -30.0 35.0 -1.99841 + -25.0 35.0 -2.01850 + -20.0 35.0 -1.60248 + -15.0 35.0 -1.29357 + -10.0 35.0 -1.28090 + -5.0 35.0 -2.69945 + 0.0 35.0 0.59195 + 5.0 35.0 0.00000 + 10.0 35.0 0.00000 + 15.0 35.0 0.00000 + 20.0 35.0 0.00000 + 25.0 35.0 0.00000 + 30.0 35.0 0.00000 + 35.0 35.0 0.00000 + 40.0 35.0 0.00000 + 45.0 35.0 0.00000 + 50.0 35.0 0.00000 + 55.0 35.0 0.00000 + 60.0 35.0 0.00000 + -60.0 40.0 -6.17635 + -55.0 40.0 -5.01129 + -50.0 40.0 -3.93950 + -45.0 40.0 -2.93043 + -40.0 40.0 -1.97787 + -35.0 40.0 -1.47061 + -30.0 40.0 -1.74907 + -25.0 40.0 -1.50302 + -20.0 40.0 -1.12724 + -15.0 40.0 -1.06712 + -10.0 40.0 -1.71500 + -5.0 40.0 -0.31646 + 0.0 40.0 0.00000 + 5.0 40.0 0.00000 + 10.0 40.0 0.00000 + 15.0 40.0 0.00000 + 20.0 40.0 0.00000 + 25.0 40.0 0.00000 + 30.0 40.0 0.00000 + 35.0 40.0 0.00000 + 40.0 40.0 0.00000 + 45.0 40.0 0.00000 + 50.0 40.0 0.00000 + 55.0 40.0 0.00000 + 60.0 40.0 0.00000 + -60.0 45.0 -5.84154 + -55.0 45.0 -4.40900 + -50.0 45.0 -2.96416 + -45.0 45.0 -1.61891 + -40.0 45.0 -1.75863 + -35.0 45.0 -1.78070 + -30.0 45.0 -1.52630 + -25.0 45.0 -1.03180 + -20.0 45.0 -0.85066 + -15.0 45.0 -1.25823 + -10.0 45.0 -0.24415 + -5.0 45.0 0.00000 + 0.0 45.0 0.00000 + 5.0 45.0 0.00000 + 10.0 45.0 0.00000 + 15.0 45.0 0.00000 + 20.0 45.0 0.00000 + 25.0 45.0 0.00000 + 30.0 45.0 0.00000 + 35.0 45.0 0.00000 + 40.0 45.0 0.00000 + 45.0 45.0 0.00000 + 50.0 45.0 0.00000 + 55.0 45.0 0.00000 + 60.0 45.0 0.00000 + -60.0 50.0 -5.34856 + -55.0 50.0 -3.63795 + -50.0 50.0 -3.30699 + -45.0 50.0 -2.40390 + -40.0 50.0 -2.19314 + -35.0 50.0 -1.78791 + -30.0 50.0 -1.12814 + -25.0 50.0 -0.71920 + -20.0 50.0 -0.87226 + -15.0 50.0 -0.86327 + -10.0 50.0 0.00000 + -5.0 50.0 0.00000 + 0.0 50.0 0.00000 + 5.0 50.0 0.00000 + 10.0 50.0 0.00000 + 15.0 50.0 0.00000 + 20.0 50.0 0.00000 + 25.0 50.0 0.00000 + 30.0 50.0 0.00000 + 35.0 50.0 0.00000 + 40.0 50.0 0.00000 + 45.0 50.0 0.00000 + 50.0 50.0 0.00000 + 55.0 50.0 0.00000 + 60.0 50.0 0.00000 + -60.0 55.0 0.00000 + -55.0 55.0 0.00000 + -50.0 55.0 -3.25149 + -45.0 55.0 -2.90526 + -40.0 55.0 -2.30892 + -35.0 55.0 -1.49327 + -30.0 55.0 -0.76993 + -25.0 55.0 0.00000 + -20.0 55.0 0.00000 + -15.0 55.0 0.00000 + -10.0 55.0 0.00000 + -5.0 55.0 0.00000 + 0.0 55.0 0.00000 + 5.0 55.0 0.00000 + 10.0 55.0 0.00000 + 15.0 55.0 0.00000 + 20.0 55.0 0.00000 + 25.0 55.0 0.00000 + 30.0 55.0 0.00000 + 35.0 55.0 0.00000 + 40.0 55.0 0.00000 + 45.0 55.0 0.00000 + 50.0 55.0 0.00000 + 55.0 55.0 0.00000 + 60.0 55.0 0.00000 + -60.0 60.0 0.00000 + -55.0 60.0 0.00000 + -50.0 60.0 0.00000 + -45.0 60.0 0.00000 + -40.0 60.0 0.00000 + -35.0 60.0 0.00000 + -30.0 60.0 0.00000 + -25.0 60.0 0.00000 + -20.0 60.0 0.00000 + -15.0 60.0 0.00000 + -10.0 60.0 0.00000 + -5.0 60.0 0.00000 + 0.0 60.0 0.00000 + 5.0 60.0 0.00000 + 10.0 60.0 0.00000 + 15.0 60.0 0.00000 + 20.0 60.0 0.00000 + 25.0 60.0 0.00000 + 30.0 60.0 0.00000 + 35.0 60.0 0.00000 + 40.0 60.0 0.00000 + 45.0 60.0 0.00000 + 50.0 60.0 0.00000 + 55.0 60.0 0.00000 + 60.0 60.0 0.00000 + +tortors 69 69 62 69 69 29 29 + -70.0 -70.0 0.00000 + -65.0 -70.0 0.00000 + -60.0 -70.0 0.00000 + -55.0 -70.0 0.00000 + -50.0 -70.0 0.00000 + -45.0 -70.0 0.00000 + -40.0 -70.0 0.00000 + -35.0 -70.0 0.00000 + -30.0 -70.0 0.00000 + -25.0 -70.0 0.00000 + -20.0 -70.0 0.00000 + -15.0 -70.0 0.00000 + -10.0 -70.0 0.00000 + -5.0 -70.0 0.00000 + 0.0 -70.0 0.00000 + 5.0 -70.0 0.00000 + 10.0 -70.0 0.00000 + 15.0 -70.0 0.00000 + 20.0 -70.0 0.00000 + 25.0 -70.0 0.00000 + 30.0 -70.0 0.00000 + 35.0 -70.0 -7.35536 + 40.0 -70.0 -6.39157 + 45.0 -70.0 -5.51336 + 50.0 -70.0 -4.70213 + 55.0 -70.0 -4.12364 + 60.0 -70.0 -3.90599 + 65.0 -70.0 -4.05868 + 70.0 -70.0 0.00000 + -70.0 -65.0 0.00000 + -65.0 -65.0 0.00000 + -60.0 -65.0 0.00000 + -55.0 -65.0 0.00000 + -50.0 -65.0 0.00000 + -45.0 -65.0 0.00000 + -40.0 -65.0 0.00000 + -35.0 -65.0 0.00000 + -30.0 -65.0 0.00000 + -25.0 -65.0 0.00000 + -20.0 -65.0 0.00000 + -15.0 -65.0 0.00000 + -10.0 -65.0 0.00000 + -5.0 -65.0 0.00000 + 0.0 -65.0 0.00000 + 5.0 -65.0 0.00000 + 10.0 -65.0 0.00000 + 15.0 -65.0 0.00000 + 20.0 -65.0 0.00000 + 25.0 -65.0 0.00000 + 30.0 -65.0 -6.41192 + 35.0 -65.0 -5.44802 + 40.0 -65.0 -4.61720 + 45.0 -65.0 -3.78560 + 50.0 -65.0 -3.09814 + 55.0 -65.0 -2.69971 + 60.0 -65.0 -2.66551 + 65.0 -65.0 -3.02608 + 70.0 -65.0 -3.73243 + -70.0 -60.0 0.00000 + -65.0 -60.0 0.00000 + -60.0 -60.0 0.00000 + -55.0 -60.0 0.00000 + -50.0 -60.0 0.00000 + -45.0 -60.0 0.00000 + -40.0 -60.0 0.00000 + -35.0 -60.0 0.00000 + -30.0 -60.0 0.00000 + -25.0 -60.0 0.00000 + -20.0 -60.0 0.00000 + -15.0 -60.0 0.00000 + -10.0 -60.0 0.00000 + -5.0 -60.0 0.00000 + 0.0 -60.0 0.00000 + 5.0 -60.0 0.00000 + 10.0 -60.0 0.00000 + 15.0 -60.0 0.00000 + 20.0 -60.0 -6.80224 + 25.0 -60.0 -5.57358 + 30.0 -60.0 -4.63259 + 35.0 -60.0 -3.82350 + 40.0 -60.0 -2.98053 + 45.0 -60.0 -2.22020 + 50.0 -60.0 -1.68302 + 55.0 -60.0 -1.46662 + 60.0 -60.0 -1.61187 + 65.0 -60.0 -2.16861 + 70.0 -60.0 -3.12062 + -70.0 -55.0 0.00000 + -65.0 -55.0 0.00000 + -60.0 -55.0 0.00000 + -55.0 -55.0 0.00000 + -50.0 -55.0 0.00000 + -45.0 -55.0 0.00000 + -40.0 -55.0 0.00000 + -35.0 -55.0 0.00000 + -30.0 -55.0 0.00000 + -25.0 -55.0 0.00000 + -20.0 -55.0 0.00000 + -15.0 -55.0 0.00000 + -10.0 -55.0 0.00000 + -5.0 -55.0 0.00000 + 0.0 -55.0 0.00000 + 5.0 -55.0 0.00000 + 10.0 -55.0 0.00000 + 15.0 -55.0 -6.18421 + 20.0 -55.0 -4.85929 + 25.0 -55.0 -3.94181 + 30.0 -55.0 -3.13278 + 35.0 -55.0 -2.28412 + 40.0 -55.0 -1.47623 + 45.0 -55.0 -0.84043 + 50.0 -55.0 -0.47338 + 55.0 -55.0 -0.45704 + 60.0 -55.0 -0.83761 + 65.0 -55.0 -1.62839 + 70.0 -55.0 -2.78769 + -70.0 -50.0 0.00000 + -65.0 -50.0 0.00000 + -60.0 -50.0 0.00000 + -55.0 -50.0 0.00000 + -50.0 -50.0 0.00000 + -45.0 -50.0 0.00000 + -40.0 -50.0 0.00000 + -35.0 -50.0 0.00000 + -30.0 -50.0 0.00000 + -25.0 -50.0 0.00000 + -20.0 -50.0 0.00000 + -15.0 -50.0 0.00000 + -10.0 -50.0 0.00000 + -5.0 -50.0 0.00000 + 0.0 -50.0 0.00000 + 5.0 -50.0 0.00000 + 10.0 -50.0 -5.77464 + 15.0 -50.0 -4.29706 + 20.0 -50.0 -3.31425 + 25.0 -50.0 -2.51387 + 30.0 -50.0 -1.69323 + 35.0 -50.0 -0.87239 + 40.0 -50.0 -0.17362 + 45.0 -50.0 0.30015 + 50.0 -50.0 0.46356 + 55.0 -50.0 0.22953 + 60.0 -50.0 -0.19891 + 65.0 -50.0 -1.23088 + 70.0 -50.0 -4.22905 + -70.0 -45.0 0.00000 + -65.0 -45.0 0.00000 + -60.0 -45.0 0.00000 + -55.0 -45.0 0.00000 + -50.0 -45.0 0.00000 + -45.0 -45.0 0.00000 + -40.0 -45.0 0.00000 + -35.0 -45.0 0.00000 + -30.0 -45.0 0.00000 + -25.0 -45.0 0.00000 + -20.0 -45.0 0.00000 + -15.0 -45.0 0.00000 + -10.0 -45.0 0.00000 + -5.0 -45.0 0.00000 + 0.0 -45.0 0.00000 + 5.0 -45.0 -5.49016 + 10.0 -45.0 -3.83953 + 15.0 -45.0 -2.81432 + 20.0 -45.0 -1.40115 + 25.0 -45.0 -1.24748 + 30.0 -45.0 -0.43812 + 35.0 -45.0 0.29489 + 40.0 -45.0 0.84200 + 45.0 -45.0 1.11542 + 50.0 -45.0 1.02545 + 55.0 -45.0 0.75833 + 60.0 -45.0 -1.73840 + 65.0 -45.0 -3.06209 + 70.0 -45.0 -4.28611 + -70.0 -40.0 0.00000 + -65.0 -40.0 0.00000 + -60.0 -40.0 0.00000 + -55.0 -40.0 0.00000 + -50.0 -40.0 0.00000 + -45.0 -40.0 0.00000 + -40.0 -40.0 0.00000 + -35.0 -40.0 0.00000 + -30.0 -40.0 0.00000 + -25.0 -40.0 0.00000 + -20.0 -40.0 0.00000 + -15.0 -40.0 0.00000 + -10.0 -40.0 0.00000 + -5.0 -40.0 0.00000 + 0.0 -40.0 -4.70793 + 5.0 -40.0 -2.99333 + 10.0 -40.0 -1.96288 + 15.0 -40.0 -1.17488 + 20.0 -40.0 -0.43859 + 25.0 -40.0 0.33188 + 30.0 -40.0 1.07703 + 35.0 -40.0 1.68420 + 40.0 -40.0 1.81828 + 45.0 -40.0 1.75159 + 50.0 -40.0 1.39542 + 55.0 -40.0 -0.97837 + 60.0 -40.0 -2.16939 + 65.0 -40.0 -3.25442 + 70.0 -40.0 -4.35030 + -70.0 -35.0 0.00000 + -65.0 -35.0 0.00000 + -60.0 -35.0 0.00000 + -55.0 -35.0 0.00000 + -50.0 -35.0 0.00000 + -45.0 -35.0 0.00000 + -40.0 -35.0 0.00000 + -35.0 -35.0 0.00000 + -30.0 -35.0 0.00000 + -25.0 -35.0 0.00000 + -20.0 -35.0 0.00000 + -15.0 -35.0 0.00000 + -10.0 -35.0 0.00000 + -5.0 -35.0 -4.56083 + 0.0 -35.0 -2.86367 + 5.0 -35.0 -1.81006 + 10.0 -35.0 -1.06444 + 15.0 -35.0 -0.42347 + 20.0 -35.0 0.23897 + 25.0 -35.0 0.91783 + 30.0 -35.0 1.52890 + 35.0 -35.0 1.98149 + 40.0 -35.0 2.17414 + 45.0 -35.0 1.67904 + 50.0 -35.0 -0.17420 + 55.0 -35.0 -1.54885 + 60.0 -35.0 -2.53790 + 65.0 -35.0 -3.49962 + 70.0 -35.0 0.00000 + -70.0 -30.0 0.00000 + -65.0 -30.0 0.00000 + -60.0 -30.0 0.00000 + -55.0 -30.0 0.00000 + -50.0 -30.0 0.00000 + -45.0 -30.0 0.00000 + -40.0 -30.0 0.00000 + -35.0 -30.0 0.00000 + -30.0 -30.0 0.00000 + -25.0 -30.0 0.00000 + -20.0 -30.0 0.00000 + -15.0 -30.0 0.00000 + -10.0 -30.0 -4.54051 + -5.0 -30.0 -2.84226 + 0.0 -30.0 -1.71079 + 5.0 -30.0 -0.97176 + 10.0 -30.0 -0.40865 + 15.0 -30.0 0.12405 + 20.0 -30.0 0.68076 + 25.0 -30.0 1.21063 + 30.0 -30.0 1.64283 + 35.0 -30.0 1.89526 + 40.0 -30.0 1.87274 + 45.0 -30.0 -0.35114 + 50.0 -30.0 -0.98740 + 55.0 -30.0 -1.79881 + 60.0 -30.0 -2.96853 + 65.0 -30.0 -3.81603 + 70.0 -30.0 0.00000 + -70.0 -25.0 0.00000 + -65.0 -25.0 0.00000 + -60.0 -25.0 0.00000 + -55.0 -25.0 0.00000 + -50.0 -25.0 0.00000 + -45.0 -25.0 0.00000 + -40.0 -25.0 0.00000 + -35.0 -25.0 0.00000 + -30.0 -25.0 0.00000 + -25.0 -25.0 0.00000 + -20.0 -25.0 0.00000 + -15.0 -25.0 -4.49063 + -10.0 -25.0 -2.78401 + -5.0 -25.0 -1.57899 + 0.0 -25.0 -0.81897 + 5.0 -25.0 -0.30565 + 10.0 -25.0 0.10575 + 15.0 -25.0 0.50455 + 20.0 -25.0 0.88631 + 25.0 -25.0 1.21754 + 30.0 -25.0 1.45176 + 35.0 -25.0 1.50253 + 40.0 -25.0 -0.62514 + 45.0 -25.0 -1.11071 + 50.0 -25.0 -1.77846 + 55.0 -25.0 -2.48613 + 60.0 -25.0 -3.49970 + 65.0 -25.0 0.00000 + 70.0 -25.0 0.00000 + -70.0 -20.0 0.00000 + -65.0 -20.0 0.00000 + -60.0 -20.0 0.00000 + -55.0 -20.0 0.00000 + -50.0 -20.0 0.00000 + -45.0 -20.0 0.00000 + -40.0 -20.0 0.00000 + -35.0 -20.0 0.00000 + -30.0 -20.0 0.00000 + -25.0 -20.0 0.00000 + -20.0 -20.0 -4.25085 + -15.0 -20.0 -2.61358 + -10.0 -20.0 -1.38585 + -5.0 -20.0 -0.59170 + 0.0 -20.0 -0.09493 + 5.0 -20.0 0.23340 + 10.0 -20.0 0.49126 + 15.0 -20.0 0.69780 + 20.0 -20.0 0.86390 + 25.0 -20.0 0.99744 + 30.0 -20.0 1.03918 + 35.0 -20.0 -1.05546 + 40.0 -20.0 -1.43982 + 45.0 -20.0 -1.99481 + 50.0 -20.0 -2.62015 + 55.0 -20.0 -2.25942 + 60.0 -20.0 0.00000 + 65.0 -20.0 0.00000 + 70.0 -20.0 0.00000 + -70.0 -15.0 0.00000 + -65.0 -15.0 0.00000 + -60.0 -15.0 0.00000 + -55.0 -15.0 0.00000 + -50.0 -15.0 0.00000 + -45.0 -15.0 0.00000 + -40.0 -15.0 0.00000 + -35.0 -15.0 0.00000 + -30.0 -15.0 0.00000 + -25.0 -15.0 -4.12180 + -20.0 -15.0 -2.43845 + -15.0 -15.0 -1.21799 + -10.0 -15.0 -0.39346 + -5.0 -15.0 0.10897 + 0.0 -15.0 0.40740 + 5.0 -15.0 0.59202 + 10.0 -15.0 0.67637 + 15.0 -15.0 0.68559 + 20.0 -15.0 0.67674 + 25.0 -15.0 0.63497 + 30.0 -15.0 -1.49836 + 35.0 -15.0 -1.85499 + 40.0 -15.0 -2.35008 + 45.0 -15.0 -2.92299 + 50.0 -15.0 -2.45149 + 55.0 -15.0 -3.50426 + 60.0 -15.0 0.00000 + 65.0 -15.0 0.00000 + 70.0 -15.0 0.00000 + -70.0 -10.0 0.00000 + -65.0 -10.0 0.00000 + -60.0 -10.0 0.00000 + -55.0 -10.0 0.00000 + -50.0 -10.0 0.00000 + -45.0 -10.0 0.00000 + -40.0 -10.0 0.00000 + -35.0 -10.0 0.00000 + -30.0 -10.0 -4.10405 + -25.0 -10.0 -2.40173 + -20.0 -10.0 -1.18264 + -15.0 -10.0 -0.35151 + -10.0 -10.0 0.15297 + -5.0 -10.0 0.45260 + 0.0 -10.0 0.64310 + 5.0 -10.0 0.70439 + 10.0 -10.0 0.63396 + 15.0 -10.0 0.52079 + 20.0 -10.0 0.38551 + 25.0 -10.0 -1.81905 + 30.0 -10.0 -2.22175 + 35.0 -10.0 -2.72757 + 40.0 -10.0 -1.80688 + 45.0 -10.0 -2.74398 + 50.0 -10.0 -3.85703 + 55.0 -10.0 0.00000 + 60.0 -10.0 0.00000 + 65.0 -10.0 0.00000 + 70.0 -10.0 0.00000 + -70.0 -5.0 0.00000 + -65.0 -5.0 0.00000 + -60.0 -5.0 0.00000 + -55.0 -5.0 0.00000 + -50.0 -5.0 0.00000 + -45.0 -5.0 0.00000 + -40.0 -5.0 0.00000 + -35.0 -5.0 -4.15106 + -30.0 -5.0 -2.52158 + -25.0 -5.0 -1.35237 + -20.0 -5.0 -0.52607 + -15.0 -5.0 -0.02414 + -10.0 -5.0 0.27577 + -5.0 -5.0 0.50208 + 0.0 -5.0 0.63792 + 5.0 -5.0 0.59774 + 10.0 -5.0 0.45217 + 15.0 -5.0 0.26409 + 20.0 -5.0 -1.97633 + 25.0 -5.0 -2.44744 + 30.0 -5.0 -3.01542 + 35.0 -5.0 -2.09823 + 40.0 -5.0 -3.09081 + 45.0 -5.0 -4.26767 + 50.0 -5.0 0.00000 + 55.0 -5.0 0.00000 + 60.0 -5.0 0.00000 + 65.0 -5.0 0.00000 + 70.0 -5.0 0.00000 + -70.0 0.0 0.00000 + -65.0 0.0 0.00000 + -60.0 0.0 0.00000 + -55.0 0.0 0.00000 + -50.0 0.0 0.00000 + -45.0 0.0 0.00000 + -40.0 0.0 -4.34406 + -35.0 0.0 -2.83022 + -30.0 0.0 -1.72949 + -25.0 0.0 -0.91498 + -20.0 0.0 -0.41633 + -15.0 0.0 -0.11711 + -10.0 0.0 0.13849 + -5.0 0.0 0.37961 + 0.0 0.0 0.47411 + 5.0 0.0 0.39130 + 10.0 0.0 0.20636 + 15.0 0.0 -2.01823 + 20.0 0.0 -2.53534 + 25.0 0.0 -3.16310 + 30.0 0.0 -2.28451 + 35.0 0.0 -3.35959 + 40.0 0.0 -4.63134 + 45.0 0.0 0.00000 + 50.0 0.0 0.00000 + 55.0 0.0 0.00000 + 60.0 0.0 0.00000 + 65.0 0.0 0.00000 + 70.0 0.0 0.00000 + -70.0 5.0 0.00000 + -65.0 5.0 0.00000 + -60.0 5.0 0.00000 + -55.0 5.0 0.00000 + -50.0 5.0 0.00000 + -45.0 5.0 0.00000 + -40.0 5.0 -3.33992 + -35.0 5.0 -2.26424 + -30.0 5.0 -1.48556 + -25.0 5.0 -0.98391 + -20.0 5.0 -0.67540 + -15.0 5.0 -0.39674 + -10.0 5.0 -0.07324 + -5.0 5.0 0.18371 + 0.0 5.0 0.25837 + 5.0 5.0 0.15378 + 10.0 5.0 -1.99620 + 15.0 5.0 -2.52901 + 20.0 5.0 -3.19310 + 25.0 5.0 -3.96923 + 30.0 5.0 -3.51255 + 35.0 5.0 -4.87195 + 40.0 5.0 -6.45350 + 45.0 5.0 0.00000 + 50.0 5.0 0.00000 + 55.0 5.0 0.00000 + 60.0 5.0 0.00000 + 65.0 5.0 0.00000 + 70.0 5.0 0.00000 + -70.0 10.0 0.00000 + -65.0 10.0 0.00000 + -60.0 10.0 0.00000 + -55.0 10.0 0.00000 + -50.0 10.0 0.00000 + -45.0 10.0 -0.09699 + -40.0 10.0 1.09800 + -35.0 10.0 -2.18665 + -30.0 10.0 -1.67750 + -25.0 10.0 -1.34867 + -20.0 10.0 -1.04832 + -15.0 10.0 -0.67323 + -10.0 10.0 -0.28930 + -5.0 10.0 -0.02654 + 0.0 10.0 0.03478 + 5.0 10.0 -1.96054 + 10.0 10.0 -2.46921 + 15.0 10.0 -0.60235 + 20.0 10.0 -1.45440 + 25.0 10.0 -3.53855 + 30.0 10.0 -4.91435 + 35.0 10.0 -6.63879 + 40.0 10.0 0.00000 + 45.0 10.0 0.00000 + 50.0 10.0 0.00000 + 55.0 10.0 0.00000 + 60.0 10.0 0.00000 + 65.0 10.0 0.00000 + 70.0 10.0 0.00000 + -70.0 15.0 0.00000 + -65.0 15.0 0.00000 + -60.0 15.0 0.00000 + -55.0 15.0 0.00000 + -50.0 15.0 0.00000 + -45.0 15.0 1.26682 + -40.0 15.0 2.21135 + -35.0 15.0 3.04857 + -30.0 15.0 3.67556 + -25.0 15.0 -1.76563 + -20.0 15.0 -1.36352 + -15.0 15.0 -0.90615 + -10.0 15.0 -0.49607 + -5.0 15.0 -0.23612 + 0.0 15.0 -1.98165 + 5.0 15.0 0.09774 + 10.0 15.0 -0.52629 + 15.0 15.0 -1.38116 + 20.0 15.0 -3.48791 + 25.0 15.0 -4.82506 + 30.0 15.0 -6.63865 + 35.0 15.0 0.00000 + 40.0 15.0 0.00000 + 45.0 15.0 0.00000 + 50.0 15.0 0.00000 + 55.0 15.0 0.00000 + 60.0 15.0 0.00000 + 65.0 15.0 0.00000 + 70.0 15.0 0.00000 + -70.0 20.0 0.00000 + -65.0 20.0 0.00000 + -60.0 20.0 0.00000 + -55.0 20.0 0.00000 + -50.0 20.0 1.08600 + -45.0 20.0 2.03968 + -40.0 20.0 2.96484 + -35.0 20.0 3.71819 + -30.0 20.0 4.12055 + -25.0 20.0 -2.09545 + -20.0 20.0 -1.61026 + -15.0 20.0 -1.11880 + -10.0 20.0 -0.70204 + -5.0 20.0 -2.15053 + 0.0 20.0 0.05354 + 5.0 20.0 -0.46679 + 10.0 20.0 -2.18819 + 15.0 20.0 -3.36511 + 20.0 20.0 -4.70377 + 25.0 20.0 -6.52015 + 30.0 20.0 0.00000 + 35.0 20.0 0.00000 + 40.0 20.0 0.00000 + 45.0 20.0 0.00000 + 50.0 20.0 0.00000 + 55.0 20.0 0.00000 + 60.0 20.0 0.00000 + 65.0 20.0 0.00000 + 70.0 20.0 0.00000 + -70.0 25.0 0.00000 + -65.0 25.0 0.00000 + -60.0 25.0 0.00000 + -55.0 25.0 0.00000 + -50.0 25.0 0.68253 + -45.0 25.0 1.84526 + -40.0 25.0 3.30576 + -35.0 25.0 3.41171 + -30.0 25.0 -2.77115 + -25.0 25.0 -2.34588 + -20.0 25.0 -1.82983 + -15.0 25.0 -1.33008 + -10.0 25.0 -2.51476 + -5.0 25.0 -0.17090 + 0.0 25.0 -1.33810 + 5.0 25.0 -2.14676 + 10.0 25.0 -3.23777 + 15.0 25.0 -4.57484 + 20.0 25.0 -6.29758 + 25.0 25.0 0.00000 + 30.0 25.0 0.00000 + 35.0 25.0 0.00000 + 40.0 25.0 0.00000 + 45.0 25.0 0.00000 + 50.0 25.0 0.00000 + 55.0 25.0 0.00000 + 60.0 25.0 0.00000 + 65.0 25.0 0.00000 + 70.0 25.0 0.00000 + -70.0 30.0 0.00000 + -65.0 30.0 0.00000 + -60.0 30.0 0.00000 + -55.0 30.0 0.08457 + -50.0 30.0 1.20541 + -45.0 30.0 1.79751 + -40.0 30.0 2.25805 + -35.0 30.0 -2.89072 + -30.0 30.0 -2.71181 + -25.0 30.0 -2.58737 + -20.0 30.0 -2.39889 + -15.0 30.0 -3.02296 + -10.0 30.0 -0.61756 + -5.0 30.0 -1.64710 + 0.0 30.0 -2.25891 + 5.0 30.0 -3.16586 + 10.0 30.0 -4.41981 + 15.0 30.0 -6.01564 + 20.0 30.0 0.00000 + 25.0 30.0 0.00000 + 30.0 30.0 0.00000 + 35.0 30.0 0.00000 + 40.0 30.0 0.00000 + 45.0 30.0 0.00000 + 50.0 30.0 0.00000 + 55.0 30.0 0.00000 + 60.0 30.0 0.00000 + 65.0 30.0 0.00000 + 70.0 30.0 0.00000 + -70.0 35.0 0.00000 + -65.0 35.0 0.00000 + -60.0 35.0 0.00000 + -55.0 35.0 -0.06902 + -50.0 35.0 0.83009 + -45.0 35.0 1.50408 + -40.0 35.0 -4.06823 + -35.0 35.0 -2.04965 + -30.0 35.0 -2.03787 + -25.0 35.0 -2.08528 + -20.0 35.0 -3.63172 + -15.0 35.0 -3.73319 + -10.0 35.0 -2.31068 + -5.0 35.0 -2.71294 + 0.0 35.0 -3.32576 + 5.0 35.0 -4.28409 + 10.0 35.0 0.00000 + 15.0 35.0 0.00000 + 20.0 35.0 0.00000 + 25.0 35.0 0.00000 + 30.0 35.0 0.00000 + 35.0 35.0 0.00000 + 40.0 35.0 0.00000 + 45.0 35.0 0.00000 + 50.0 35.0 0.00000 + 55.0 35.0 0.00000 + 60.0 35.0 0.00000 + 65.0 35.0 0.00000 + 70.0 35.0 0.00000 + -70.0 40.0 0.00000 + -65.0 40.0 0.00000 + -60.0 40.0 0.00000 + -55.0 40.0 -0.18309 + -50.0 40.0 0.65098 + -45.0 40.0 1.17821 + -40.0 40.0 -3.16353 + -35.0 40.0 -1.11172 + -30.0 40.0 0.65011 + -25.0 40.0 0.57148 + -20.0 40.0 0.11875 + -15.0 40.0 -0.89921 + -10.0 40.0 -2.62749 + -5.0 40.0 -3.82396 + 0.0 40.0 -4.11637 + 5.0 40.0 0.00000 + 10.0 40.0 0.00000 + 15.0 40.0 0.00000 + 20.0 40.0 0.00000 + 25.0 40.0 0.00000 + 30.0 40.0 0.00000 + 35.0 40.0 0.00000 + 40.0 40.0 0.00000 + 45.0 40.0 0.00000 + 50.0 40.0 0.00000 + 55.0 40.0 0.00000 + 60.0 40.0 0.00000 + 65.0 40.0 0.00000 + 70.0 40.0 0.00000 + -70.0 45.0 0.00000 + -65.0 45.0 0.00000 + -60.0 45.0 -1.16370 + -55.0 45.0 -0.25400 + -50.0 45.0 0.44283 + -45.0 45.0 -2.47844 + -40.0 45.0 -2.18114 + -35.0 45.0 0.27906 + -30.0 45.0 -0.99801 + -25.0 45.0 -0.07649 + -20.0 45.0 -0.95368 + -15.0 45.0 -2.42049 + -10.0 45.0 -3.89964 + -5.0 45.0 -4.64287 + 0.0 45.0 0.00000 + 5.0 45.0 0.00000 + 10.0 45.0 0.00000 + 15.0 45.0 0.00000 + 20.0 45.0 0.00000 + 25.0 45.0 0.00000 + 30.0 45.0 0.00000 + 35.0 45.0 0.00000 + 40.0 45.0 0.00000 + 45.0 45.0 0.00000 + 50.0 45.0 0.00000 + 55.0 45.0 0.00000 + 60.0 45.0 0.00000 + 65.0 45.0 0.00000 + 70.0 45.0 0.00000 + -70.0 50.0 0.00000 + -65.0 50.0 0.00000 + -60.0 50.0 0.00000 + -55.0 50.0 -0.34022 + -50.0 50.0 -1.91537 + -45.0 50.0 -1.59077 + -40.0 50.0 -1.14958 + -35.0 50.0 0.01919 + -30.0 50.0 -0.21509 + -25.0 50.0 -0.89076 + -20.0 50.0 -2.02569 + -15.0 50.0 -3.42838 + -10.0 50.0 0.00000 + -5.0 50.0 0.00000 + 0.0 50.0 0.00000 + 5.0 50.0 0.00000 + 10.0 50.0 0.00000 + 15.0 50.0 0.00000 + 20.0 50.0 0.00000 + 25.0 50.0 0.00000 + 30.0 50.0 0.00000 + 35.0 50.0 0.00000 + 40.0 50.0 0.00000 + 45.0 50.0 0.00000 + 50.0 50.0 0.00000 + 55.0 50.0 0.00000 + 60.0 50.0 0.00000 + 65.0 50.0 0.00000 + 70.0 50.0 0.00000 + -70.0 55.0 0.00000 + -65.0 55.0 0.00000 + -60.0 55.0 0.00000 + -55.0 55.0 -1.49765 + -50.0 55.0 -1.09687 + -45.0 55.0 -0.98897 + -40.0 55.0 -1.45115 + -35.0 55.0 -0.33631 + -30.0 55.0 -0.78973 + -25.0 55.0 -1.57784 + -20.0 55.0 -2.73801 + -15.0 55.0 0.00000 + -10.0 55.0 0.00000 + -5.0 55.0 0.00000 + 0.0 55.0 0.00000 + 5.0 55.0 0.00000 + 10.0 55.0 0.00000 + 15.0 55.0 0.00000 + 20.0 55.0 0.00000 + 25.0 55.0 0.00000 + 30.0 55.0 0.00000 + 35.0 55.0 0.00000 + 40.0 55.0 0.00000 + 45.0 55.0 0.00000 + 50.0 55.0 0.00000 + 55.0 55.0 0.00000 + 60.0 55.0 0.00000 + 65.0 55.0 0.00000 + 70.0 55.0 0.00000 + -70.0 60.0 0.00000 + -65.0 60.0 0.00000 + -60.0 60.0 0.00000 + -55.0 60.0 0.00000 + -50.0 60.0 -3.67961 + -45.0 60.0 -1.42051 + -40.0 60.0 -1.87316 + -35.0 60.0 -0.67832 + -30.0 60.0 -1.25484 + -25.0 60.0 0.00000 + -20.0 60.0 0.00000 + -15.0 60.0 0.00000 + -10.0 60.0 0.00000 + -5.0 60.0 0.00000 + 0.0 60.0 0.00000 + 5.0 60.0 0.00000 + 10.0 60.0 0.00000 + 15.0 60.0 0.00000 + 20.0 60.0 0.00000 + 25.0 60.0 0.00000 + 30.0 60.0 0.00000 + 35.0 60.0 0.00000 + 40.0 60.0 0.00000 + 45.0 60.0 0.00000 + 50.0 60.0 0.00000 + 55.0 60.0 0.00000 + 60.0 60.0 0.00000 + 65.0 60.0 0.00000 + 70.0 60.0 0.00000 + -70.0 65.0 0.00000 + -65.0 65.0 0.00000 + -60.0 65.0 0.00000 + -55.0 65.0 0.00000 + -50.0 65.0 0.00000 + -45.0 65.0 0.00000 + -40.0 65.0 0.00000 + -35.0 65.0 0.00000 + -30.0 65.0 0.00000 + -25.0 65.0 0.00000 + -20.0 65.0 0.00000 + -15.0 65.0 0.00000 + -10.0 65.0 0.00000 + -5.0 65.0 0.00000 + 0.0 65.0 0.00000 + 5.0 65.0 0.00000 + 10.0 65.0 0.00000 + 15.0 65.0 0.00000 + 20.0 65.0 0.00000 + 25.0 65.0 0.00000 + 30.0 65.0 0.00000 + 35.0 65.0 0.00000 + 40.0 65.0 0.00000 + 45.0 65.0 0.00000 + 50.0 65.0 0.00000 + 55.0 65.0 0.00000 + 60.0 65.0 0.00000 + 65.0 65.0 0.00000 + 70.0 65.0 0.00000 + -70.0 70.0 0.00000 + -65.0 70.0 0.00000 + -60.0 70.0 0.00000 + -55.0 70.0 0.00000 + -50.0 70.0 0.00000 + -45.0 70.0 0.00000 + -40.0 70.0 0.00000 + -35.0 70.0 0.00000 + -30.0 70.0 0.00000 + -25.0 70.0 0.00000 + -20.0 70.0 0.00000 + -15.0 70.0 0.00000 + -10.0 70.0 0.00000 + -5.0 70.0 0.00000 + 0.0 70.0 0.00000 + 5.0 70.0 0.00000 + 10.0 70.0 0.00000 + 15.0 70.0 0.00000 + 20.0 70.0 0.00000 + 25.0 70.0 0.00000 + 30.0 70.0 0.00000 + 35.0 70.0 0.00000 + 40.0 70.0 0.00000 + 45.0 70.0 0.00000 + 50.0 70.0 0.00000 + 55.0 70.0 0.00000 + 60.0 70.0 0.00000 + 65.0 70.0 0.00000 + 70.0 70.0 0.00000 + +tortors 63 63 68 63 63 25 25 + -60.0 -60.0 0.00000 + -55.0 -60.0 0.00000 + -50.0 -60.0 0.00000 + -45.0 -60.0 0.00000 + -40.0 -60.0 0.00000 + -35.0 -60.0 0.00000 + -30.0 -60.0 0.00000 + -25.0 -60.0 0.00000 + -20.0 -60.0 0.00000 + -15.0 -60.0 0.00000 + -10.0 -60.0 0.00000 + -5.0 -60.0 0.00000 + 0.0 -60.0 0.00000 + 5.0 -60.0 0.00000 + 10.0 -60.0 0.00000 + 15.0 -60.0 0.00000 + 20.0 -60.0 -5.83580 + 25.0 -60.0 -4.10131 + 30.0 -60.0 -3.15720 + 35.0 -60.0 -2.52015 + 40.0 -60.0 -1.95291 + 45.0 -60.0 -1.48406 + 50.0 -60.0 -1.27507 + 55.0 -60.0 -1.53562 + 60.0 -60.0 -2.41753 + -60.0 -55.0 0.00000 + -55.0 -55.0 0.00000 + -50.0 -55.0 0.00000 + -45.0 -55.0 0.00000 + -40.0 -55.0 0.00000 + -35.0 -55.0 0.00000 + -30.0 -55.0 0.00000 + -25.0 -55.0 0.00000 + -20.0 -55.0 0.00000 + -15.0 -55.0 0.00000 + -10.0 -55.0 0.00000 + -5.0 -55.0 0.00000 + 0.0 -55.0 0.00000 + 5.0 -55.0 0.00000 + 10.0 -55.0 0.00000 + 15.0 -55.0 -5.05305 + 20.0 -55.0 -3.33928 + 25.0 -55.0 -2.41441 + 30.0 -55.0 -1.79519 + 35.0 -55.0 -1.22985 + 40.0 -55.0 -0.70728 + 45.0 -55.0 -0.37932 + 50.0 -55.0 -0.46399 + 55.0 -55.0 -1.18381 + 60.0 -55.0 -2.40715 + -60.0 -50.0 0.00000 + -55.0 -50.0 0.00000 + -50.0 -50.0 0.00000 + -45.0 -50.0 0.00000 + -40.0 -50.0 0.00000 + -35.0 -50.0 0.00000 + -30.0 -50.0 0.00000 + -25.0 -50.0 0.00000 + -20.0 -50.0 0.00000 + -15.0 -50.0 0.00000 + -10.0 -50.0 0.00000 + -5.0 -50.0 0.00000 + 0.0 -50.0 0.00000 + 5.0 -50.0 0.00000 + 10.0 -50.0 -4.56366 + 15.0 -50.0 -2.72989 + 20.0 -50.0 -1.83452 + 25.0 -50.0 -1.24516 + 30.0 -50.0 -0.69635 + 35.0 -50.0 -0.14499 + 40.0 -50.0 0.27269 + 45.0 -50.0 0.33534 + 50.0 -50.0 -0.22901 + 55.0 -50.0 -1.32087 + 60.0 -50.0 -2.70210 + -60.0 -45.0 0.00000 + -55.0 -45.0 0.00000 + -50.0 -45.0 0.00000 + -45.0 -45.0 0.00000 + -40.0 -45.0 0.00000 + -35.0 -45.0 0.00000 + -30.0 -45.0 0.00000 + -25.0 -45.0 0.00000 + -20.0 -45.0 0.00000 + -15.0 -45.0 0.00000 + -10.0 -45.0 0.00000 + -5.0 -45.0 0.00000 + 0.0 -45.0 0.00000 + 5.0 -45.0 -4.28901 + 10.0 -45.0 -2.36540 + 15.0 -45.0 -1.44799 + 20.0 -45.0 -0.87305 + 25.0 -45.0 -0.35540 + 30.0 -45.0 0.19884 + 35.0 -45.0 0.68121 + 40.0 -45.0 0.87422 + 45.0 -45.0 0.47311 + 50.0 -45.0 -0.48811 + 55.0 -45.0 -1.75459 + 60.0 -45.0 -3.23250 + -60.0 -40.0 0.00000 + -55.0 -40.0 0.00000 + -50.0 -40.0 0.00000 + -45.0 -40.0 0.00000 + -40.0 -40.0 0.00000 + -35.0 -40.0 0.00000 + -30.0 -40.0 0.00000 + -25.0 -40.0 0.00000 + -20.0 -40.0 0.00000 + -15.0 -40.0 0.00000 + -10.0 -40.0 0.00000 + -5.0 -40.0 0.00000 + 0.0 -40.0 -4.21609 + 5.0 -40.0 -2.19871 + 10.0 -40.0 -1.23713 + 15.0 -40.0 -0.67214 + 20.0 -40.0 -0.19771 + 25.0 -40.0 0.33857 + 30.0 -40.0 0.86240 + 35.0 -40.0 1.16997 + 40.0 -40.0 0.93497 + 45.0 -40.0 0.12428 + 50.0 -40.0 -1.01473 + 55.0 -40.0 -2.39457 + 60.0 -40.0 -3.96385 + -60.0 -35.0 0.00000 + -55.0 -35.0 0.00000 + -50.0 -35.0 0.00000 + -45.0 -35.0 0.00000 + -40.0 -35.0 0.00000 + -35.0 -35.0 0.00000 + -30.0 -35.0 0.00000 + -25.0 -35.0 0.00000 + -20.0 -35.0 0.00000 + -15.0 -35.0 0.00000 + -10.0 -35.0 0.00000 + -5.0 -35.0 -4.30432 + 0.0 -35.0 -2.21293 + 5.0 -35.0 -1.19409 + 10.0 -35.0 -0.63370 + 15.0 -35.0 -0.19059 + 20.0 -35.0 0.31095 + 25.0 -35.0 0.85451 + 30.0 -35.0 1.25911 + 35.0 -35.0 1.18705 + 40.0 -35.0 0.52783 + 45.0 -35.0 -0.48037 + 50.0 -35.0 -1.75861 + 55.0 -35.0 -3.25751 + 60.0 -35.0 -4.90158 + -60.0 -30.0 0.00000 + -55.0 -30.0 0.00000 + -50.0 -30.0 0.00000 + -45.0 -30.0 0.00000 + -40.0 -30.0 0.00000 + -35.0 -30.0 0.00000 + -30.0 -30.0 0.00000 + -25.0 -30.0 0.00000 + -20.0 -30.0 0.00000 + -15.0 -30.0 0.00000 + -10.0 -30.0 -4.51066 + -5.0 -30.0 -2.37566 + 0.0 -30.0 -1.30490 + 5.0 -30.0 -0.71830 + 10.0 -30.0 -0.30009 + 15.0 -30.0 0.15906 + 20.0 -30.0 0.69957 + 25.0 -30.0 1.17910 + 30.0 -30.0 1.25487 + 35.0 -30.0 0.73672 + 40.0 -30.0 -0.14813 + 45.0 -30.0 -1.32471 + 50.0 -30.0 -2.74217 + 55.0 -30.0 -4.26407 + 60.0 -30.0 -5.95061 + -60.0 -25.0 0.00000 + -55.0 -25.0 0.00000 + -50.0 -25.0 0.00000 + -45.0 -25.0 0.00000 + -40.0 -25.0 0.00000 + -35.0 -25.0 0.00000 + -30.0 -25.0 0.00000 + -25.0 -25.0 0.00000 + -20.0 -25.0 0.00000 + -15.0 -25.0 -4.77307 + -10.0 -25.0 -2.63312 + -5.0 -25.0 -1.51674 + 0.0 -25.0 -0.89776 + 5.0 -25.0 -0.49416 + 10.0 -25.0 -0.07935 + 15.0 -25.0 0.44113 + 20.0 -25.0 0.96622 + 25.0 -25.0 1.16381 + 30.0 -25.0 0.77087 + 35.0 -25.0 -0.00358 + 40.0 -25.0 -1.07229 + 45.0 -25.0 -2.36674 + 50.0 -25.0 -3.71138 + 55.0 -25.0 -5.27158 + 60.0 -25.0 0.00000 + -60.0 -20.0 0.00000 + -55.0 -20.0 0.00000 + -50.0 -20.0 0.00000 + -45.0 -20.0 0.00000 + -40.0 -20.0 0.00000 + -35.0 -20.0 0.00000 + -30.0 -20.0 0.00000 + -25.0 -20.0 0.00000 + -20.0 -20.0 -5.09315 + -15.0 -20.0 -2.95517 + -10.0 -20.0 -1.80460 + -5.0 -20.0 -1.14660 + 0.0 -20.0 -0.74759 + 5.0 -20.0 -0.38000 + 10.0 -20.0 0.10328 + 15.0 -20.0 0.64809 + 20.0 -20.0 0.94323 + 25.0 -20.0 0.65745 + 30.0 -20.0 -0.01915 + 35.0 -20.0 -0.95485 + 40.0 -20.0 -2.08050 + 45.0 -20.0 -3.25913 + 50.0 -20.0 -4.71133 + 55.0 -20.0 -6.63971 + 60.0 -20.0 0.00000 + -60.0 -15.0 0.00000 + -55.0 -15.0 0.00000 + -50.0 -15.0 0.00000 + -45.0 -15.0 0.00000 + -40.0 -15.0 0.00000 + -35.0 -15.0 0.00000 + -30.0 -15.0 0.00000 + -25.0 -15.0 -5.45034 + -20.0 -15.0 -3.32685 + -15.0 -15.0 -2.15296 + -10.0 -15.0 -1.45232 + -5.0 -15.0 -1.04803 + 0.0 -15.0 -0.72396 + 5.0 -15.0 -0.29232 + 10.0 -15.0 0.24800 + 15.0 -15.0 0.61448 + 20.0 -15.0 0.42054 + 25.0 -15.0 -0.15392 + 30.0 -15.0 -0.91776 + 35.0 -15.0 -1.87264 + 40.0 -15.0 -2.98568 + 45.0 -15.0 -4.40337 + 50.0 -15.0 -6.22766 + 55.0 -15.0 0.00000 + 60.0 -15.0 0.00000 + -60.0 -10.0 0.00000 + -55.0 -10.0 0.00000 + -50.0 -10.0 0.00000 + -45.0 -10.0 0.00000 + -40.0 -10.0 0.00000 + -35.0 -10.0 0.00000 + -30.0 -10.0 -5.81449 + -25.0 -10.0 -3.73128 + -20.0 -10.0 -2.08624 + -15.0 -10.0 -1.62464 + -10.0 -10.0 -1.41500 + -5.0 -10.0 -1.24102 + 0.0 -10.0 -0.92284 + 5.0 -10.0 -0.21338 + 10.0 -10.0 0.20700 + 15.0 -10.0 0.09521 + 20.0 -10.0 -0.36907 + 25.0 -10.0 -0.94672 + 30.0 -10.0 -1.74422 + 35.0 -10.0 -3.08295 + 40.0 -10.0 -4.46307 + 45.0 -10.0 -6.00104 + 50.0 -10.0 0.00000 + 55.0 -10.0 0.00000 + 60.0 -10.0 0.00000 + -60.0 -5.0 0.00000 + -55.0 -5.0 0.00000 + -50.0 -5.0 0.00000 + -45.0 -5.0 0.00000 + -40.0 -5.0 0.00000 + -35.0 -5.0 -6.15091 + -30.0 -5.0 -3.55861 + -25.0 -5.0 -2.57195 + -20.0 -5.0 -2.02681 + -15.0 -5.0 -1.78924 + -10.0 -5.0 -1.64777 + -5.0 -5.0 -1.39537 + 0.0 -5.0 -0.96900 + 5.0 -5.0 -0.25290 + 10.0 -5.0 -0.28746 + 15.0 -5.0 -0.63064 + 20.0 -5.0 -1.06625 + 25.0 -5.0 -1.47532 + 30.0 -5.0 -3.00948 + 35.0 -5.0 -4.44984 + 40.0 -5.0 -5.95855 + 45.0 -5.0 0.00000 + 50.0 -5.0 0.00000 + 55.0 -5.0 0.00000 + 60.0 -5.0 0.00000 + -60.0 0.0 0.00000 + -55.0 0.0 0.00000 + -50.0 0.0 0.00000 + -45.0 0.0 0.00000 + -40.0 0.0 -6.45417 + -35.0 0.0 -4.62143 + -30.0 0.0 -3.08129 + -25.0 0.0 -2.45978 + -20.0 0.0 -2.17723 + -15.0 0.0 -2.03416 + -10.0 0.0 -1.80951 + -5.0 0.0 -1.38533 + 0.0 0.0 -0.90395 + 5.0 0.0 -0.42779 + 10.0 0.0 -0.94115 + 15.0 0.0 -1.30965 + 20.0 0.0 -1.38555 + 25.0 0.0 -2.90457 + 30.0 0.0 -4.37987 + 35.0 0.0 -6.02007 + 40.0 0.0 -8.06281 + 45.0 0.0 0.00000 + 50.0 0.0 0.00000 + 55.0 0.0 0.00000 + 60.0 0.0 0.00000 + -60.0 5.0 0.00000 + -55.0 5.0 0.00000 + -50.0 5.0 0.00000 + -45.0 5.0 0.00000 + -40.0 5.0 -5.20922 + -35.0 5.0 -4.00563 + -30.0 5.0 -2.89695 + -25.0 5.0 -2.56096 + -20.0 5.0 -2.39153 + -15.0 5.0 -2.16389 + -10.0 5.0 -1.71843 + -5.0 5.0 -1.13558 + 0.0 5.0 -0.58070 + 5.0 5.0 -0.37062 + 10.0 5.0 -0.69307 + 15.0 5.0 -2.14963 + 20.0 5.0 -2.75680 + 25.0 5.0 -4.24320 + 30.0 5.0 -5.93490 + 35.0 5.0 -8.09825 + 40.0 5.0 0.00000 + 45.0 5.0 0.00000 + 50.0 5.0 0.00000 + 55.0 5.0 0.00000 + 60.0 5.0 0.00000 + -60.0 10.0 0.00000 + -55.0 10.0 0.00000 + -50.0 10.0 0.00000 + -45.0 10.0 -5.89887 + -40.0 10.0 -4.61032 + -35.0 10.0 -3.33093 + -30.0 10.0 -2.93891 + -25.0 10.0 -2.72616 + -20.0 10.0 -2.47611 + -15.0 10.0 -2.00860 + -10.0 10.0 -1.37221 + -5.0 10.0 -0.95195 + 0.0 10.0 -0.53303 + 5.0 10.0 -0.80005 + 10.0 10.0 -1.49429 + 15.0 10.0 7.14810 + 20.0 10.0 -4.07134 + 25.0 10.0 -5.75519 + 30.0 10.0 -8.08174 + 35.0 10.0 0.00000 + 40.0 10.0 0.00000 + 45.0 10.0 0.00000 + 50.0 10.0 0.00000 + 55.0 10.0 0.00000 + 60.0 10.0 0.00000 + -60.0 15.0 0.00000 + -55.0 15.0 0.00000 + -50.0 15.0 -6.67389 + -45.0 15.0 -5.28891 + -40.0 15.0 -3.78623 + -35.0 15.0 -3.32858 + -30.0 15.0 -3.05602 + -25.0 15.0 -2.76550 + -20.0 15.0 -2.27464 + -15.0 15.0 -1.61201 + -10.0 15.0 -1.20651 + -5.0 15.0 -0.72170 + 0.0 15.0 -0.98022 + 5.0 15.0 -1.60778 + 10.0 15.0 -2.48238 + 15.0 15.0 -3.59773 + 20.0 15.0 -5.53243 + 25.0 15.0 -7.87853 + 30.0 15.0 0.00000 + 35.0 15.0 0.00000 + 40.0 15.0 0.00000 + 45.0 15.0 0.00000 + 50.0 15.0 0.00000 + 55.0 15.0 0.00000 + 60.0 15.0 0.00000 + -60.0 20.0 0.00000 + -55.0 20.0 0.00000 + -50.0 20.0 -6.06207 + -45.0 20.0 -4.30777 + -40.0 20.0 -3.76330 + -35.0 20.0 -3.41033 + -30.0 20.0 -3.05833 + -25.0 20.0 -2.53504 + -20.0 20.0 -1.86271 + -15.0 20.0 -1.49943 + -10.0 20.0 -1.52244 + -5.0 20.0 -1.22400 + 0.0 20.0 -1.84097 + 5.0 20.0 -2.58326 + 10.0 20.0 -3.55006 + 15.0 20.0 -4.80046 + 20.0 20.0 -6.77925 + 25.0 20.0 0.00000 + 30.0 20.0 0.00000 + 35.0 20.0 0.00000 + 40.0 20.0 0.00000 + 45.0 20.0 0.00000 + 50.0 20.0 0.00000 + 55.0 20.0 0.00000 + 60.0 20.0 0.00000 + -60.0 25.0 0.00000 + -55.0 25.0 -6.71688 + -50.0 25.0 -4.93440 + -45.0 25.0 -4.28613 + -40.0 25.0 -3.82646 + -35.0 25.0 -3.38948 + -30.0 25.0 -2.81826 + -25.0 25.0 -2.14956 + -20.0 25.0 -1.87936 + -15.0 25.0 -2.03259 + -10.0 25.0 -2.25445 + -5.0 25.0 -2.23288 + 0.0 25.0 -2.87541 + 5.0 25.0 -3.62505 + 10.0 25.0 -4.69355 + 15.0 25.0 -6.42515 + 20.0 25.0 0.00000 + 25.0 25.0 0.00000 + 30.0 25.0 0.00000 + 35.0 25.0 0.00000 + 40.0 25.0 0.00000 + 45.0 25.0 0.00000 + 50.0 25.0 0.00000 + 55.0 25.0 0.00000 + 60.0 25.0 0.00000 + -60.0 30.0 0.00000 + -55.0 30.0 -6.21631 + -50.0 30.0 -4.92852 + -45.0 30.0 -4.34573 + -40.0 30.0 -3.80246 + -35.0 30.0 -3.15604 + -30.0 30.0 -2.46375 + -25.0 30.0 -0.88023 + -20.0 30.0 0.61686 + -15.0 30.0 2.27087 + -10.0 30.0 1.72623 + -5.0 30.0 0.38929 + 0.0 30.0 -1.41604 + 5.0 30.0 -4.69785 + 10.0 30.0 -4.02859 + 15.0 30.0 0.00000 + 20.0 30.0 0.00000 + 25.0 30.0 0.00000 + 30.0 30.0 0.00000 + 35.0 30.0 0.00000 + 40.0 30.0 0.00000 + 45.0 30.0 0.00000 + 50.0 30.0 0.00000 + 55.0 30.0 0.00000 + 60.0 30.0 0.00000 + -60.0 35.0 -7.11110 + -55.0 35.0 -5.71246 + -50.0 35.0 -5.15556 + -45.0 35.0 -4.48298 + -40.0 35.0 -3.77140 + -35.0 35.0 -2.82176 + -30.0 35.0 1.97933 + -25.0 35.0 1.83302 + -20.0 35.0 1.99498 + -15.0 35.0 1.66745 + -10.0 35.0 0.76867 + -5.0 35.0 -0.91706 + 0.0 35.0 -1.26883 + 5.0 35.0 0.00000 + 10.0 35.0 0.00000 + 15.0 35.0 0.00000 + 20.0 35.0 0.00000 + 25.0 35.0 0.00000 + 30.0 35.0 0.00000 + 35.0 35.0 0.00000 + 40.0 35.0 0.00000 + 45.0 35.0 0.00000 + 50.0 35.0 0.00000 + 55.0 35.0 0.00000 + 60.0 35.0 0.00000 + -60.0 40.0 -6.65370 + -55.0 40.0 -6.00115 + -50.0 40.0 -5.16227 + -45.0 40.0 -4.13831 + -40.0 40.0 -2.88134 + -35.0 40.0 -1.14214 + -30.0 40.0 0.30513 + -25.0 40.0 1.70995 + -20.0 40.0 1.50302 + -15.0 40.0 0.75237 + -10.0 40.0 -0.56942 + -5.0 40.0 -1.00446 + 0.0 40.0 0.00000 + 5.0 40.0 0.00000 + 10.0 40.0 0.00000 + 15.0 40.0 0.00000 + 20.0 40.0 0.00000 + 25.0 40.0 0.00000 + 30.0 40.0 0.00000 + 35.0 40.0 0.00000 + 40.0 40.0 0.00000 + 45.0 40.0 0.00000 + 50.0 40.0 0.00000 + 55.0 40.0 0.00000 + 60.0 40.0 0.00000 + -60.0 45.0 -6.79279 + -55.0 45.0 -5.74938 + -50.0 45.0 -4.52149 + -45.0 45.0 -3.01283 + -40.0 45.0 -1.23356 + -35.0 45.0 0.14494 + -30.0 45.0 0.67081 + -25.0 45.0 1.36431 + -20.0 45.0 0.78324 + -15.0 45.0 -0.30187 + -10.0 45.0 -0.58731 + -5.0 45.0 0.00000 + 0.0 45.0 0.00000 + 5.0 45.0 0.00000 + 10.0 45.0 0.00000 + 15.0 45.0 0.00000 + 20.0 45.0 0.00000 + 25.0 45.0 0.00000 + 30.0 45.0 0.00000 + 35.0 45.0 0.00000 + 40.0 45.0 0.00000 + 45.0 45.0 0.00000 + 50.0 45.0 0.00000 + 55.0 45.0 0.00000 + 60.0 45.0 0.00000 + -60.0 50.0 0.00000 + -55.0 50.0 -5.31465 + -50.0 50.0 -3.18818 + -45.0 50.0 -1.35243 + -40.0 50.0 0.01198 + -35.0 50.0 0.51944 + -30.0 50.0 1.18114 + -25.0 50.0 0.83239 + -20.0 50.0 0.01828 + -15.0 50.0 0.00004 + -10.0 50.0 0.00000 + -5.0 50.0 0.00000 + 0.0 50.0 0.00000 + 5.0 50.0 0.00000 + 10.0 50.0 0.00000 + 15.0 50.0 0.00000 + 20.0 50.0 0.00000 + 25.0 50.0 0.00000 + 30.0 50.0 0.00000 + 35.0 50.0 0.00000 + 40.0 50.0 0.00000 + 45.0 50.0 0.00000 + 50.0 50.0 0.00000 + 55.0 50.0 0.00000 + 60.0 50.0 0.00000 + -60.0 55.0 0.00000 + -55.0 55.0 0.00000 + -50.0 55.0 -1.48994 + -45.0 55.0 0.06393 + -40.0 55.0 0.76718 + -35.0 55.0 0.33348 + -30.0 55.0 0.79545 + -25.0 55.0 0.00000 + -20.0 55.0 0.00000 + -15.0 55.0 0.00000 + -10.0 55.0 0.00000 + -5.0 55.0 0.00000 + 0.0 55.0 0.00000 + 5.0 55.0 0.00000 + 10.0 55.0 0.00000 + 15.0 55.0 0.00000 + 20.0 55.0 0.00000 + 25.0 55.0 0.00000 + 30.0 55.0 0.00000 + 35.0 55.0 0.00000 + 40.0 55.0 0.00000 + 45.0 55.0 0.00000 + 50.0 55.0 0.00000 + 55.0 55.0 0.00000 + 60.0 55.0 0.00000 + -60.0 60.0 0.00000 + -55.0 60.0 0.00000 + -50.0 60.0 0.00000 + -45.0 60.0 0.00000 + -40.0 60.0 0.00000 + -35.0 60.0 0.00000 + -30.0 60.0 0.00000 + -25.0 60.0 0.00000 + -20.0 60.0 0.00000 + -15.0 60.0 0.00000 + -10.0 60.0 0.00000 + -5.0 60.0 0.00000 + 0.0 60.0 0.00000 + 5.0 60.0 0.00000 + 10.0 60.0 0.00000 + 15.0 60.0 0.00000 + 20.0 60.0 0.00000 + 25.0 60.0 0.00000 + 30.0 60.0 0.00000 + 35.0 60.0 0.00000 + 40.0 60.0 0.00000 + 45.0 60.0 0.00000 + 50.0 60.0 0.00000 + 55.0 60.0 0.00000 + 60.0 60.0 0.00000 + +tortors 69 69 68 69 69 29 29 + -70.0 -70.0 0.00000 + -65.0 -70.0 0.00000 + -60.0 -70.0 0.00000 + -55.0 -70.0 0.00000 + -50.0 -70.0 0.00000 + -45.0 -70.0 0.00000 + -40.0 -70.0 0.00000 + -35.0 -70.0 0.00000 + -30.0 -70.0 0.00000 + -25.0 -70.0 0.00000 + -20.0 -70.0 0.00000 + -15.0 -70.0 0.00000 + -10.0 -70.0 0.00000 + -5.0 -70.0 0.00000 + 0.0 -70.0 0.00000 + 5.0 -70.0 0.00000 + 10.0 -70.0 0.00000 + 15.0 -70.0 0.00000 + 20.0 -70.0 0.00000 + 25.0 -70.0 0.00000 + 30.0 -70.0 0.00000 + 35.0 -70.0 -7.54942 + 40.0 -70.0 -6.80674 + 45.0 -70.0 -6.03340 + 50.0 -70.0 -5.25706 + 55.0 -70.0 -4.61832 + 60.0 -70.0 -4.23225 + 65.0 -70.0 -4.11835 + 70.0 -70.0 0.00000 + -70.0 -65.0 0.00000 + -65.0 -65.0 0.00000 + -60.0 -65.0 0.00000 + -55.0 -65.0 0.00000 + -50.0 -65.0 0.00000 + -45.0 -65.0 0.00000 + -40.0 -65.0 0.00000 + -35.0 -65.0 0.00000 + -30.0 -65.0 0.00000 + -25.0 -65.0 0.00000 + -20.0 -65.0 0.00000 + -15.0 -65.0 0.00000 + -10.0 -65.0 0.00000 + -5.0 -65.0 0.00000 + 0.0 -65.0 0.00000 + 5.0 -65.0 0.00000 + 10.0 -65.0 0.00000 + 15.0 -65.0 0.00000 + 20.0 -65.0 0.00000 + 25.0 -65.0 0.00000 + 30.0 -65.0 -6.92038 + 35.0 -65.0 -6.22416 + 40.0 -65.0 -5.50740 + 45.0 -65.0 -4.74400 + 50.0 -65.0 -4.05069 + 55.0 -65.0 -3.55238 + 60.0 -65.0 -3.31098 + 65.0 -65.0 -3.34400 + 70.0 -65.0 -3.65503 + -70.0 -60.0 0.00000 + -65.0 -60.0 0.00000 + -60.0 -60.0 0.00000 + -55.0 -60.0 0.00000 + -50.0 -60.0 0.00000 + -45.0 -60.0 0.00000 + -40.0 -60.0 0.00000 + -35.0 -60.0 0.00000 + -30.0 -60.0 0.00000 + -25.0 -60.0 0.00000 + -20.0 -60.0 0.00000 + -15.0 -60.0 0.00000 + -10.0 -60.0 0.00000 + -5.0 -60.0 0.00000 + 0.0 -60.0 0.00000 + 5.0 -60.0 0.00000 + 10.0 -60.0 0.00000 + 15.0 -60.0 0.00000 + 20.0 -60.0 -7.31368 + 25.0 -60.0 -6.31256 + 30.0 -60.0 -5.61848 + 35.0 -60.0 -4.93623 + 40.0 -60.0 -4.18671 + 45.0 -60.0 -3.45990 + 50.0 -60.0 -2.87558 + 55.0 -60.0 -2.51236 + 60.0 -60.0 -2.42291 + 65.0 -60.0 -3.48338 + 70.0 -60.0 -4.24029 + -70.0 -55.0 0.00000 + -65.0 -55.0 0.00000 + -60.0 -55.0 0.00000 + -55.0 -55.0 0.00000 + -50.0 -55.0 0.00000 + -45.0 -55.0 0.00000 + -40.0 -55.0 0.00000 + -35.0 -55.0 0.00000 + -30.0 -55.0 0.00000 + -25.0 -55.0 0.00000 + -20.0 -55.0 0.00000 + -15.0 -55.0 0.00000 + -10.0 -55.0 0.00000 + -5.0 -55.0 0.00000 + 0.0 -55.0 0.00000 + 5.0 -55.0 0.00000 + 10.0 -55.0 0.00000 + 15.0 -55.0 -6.90085 + 20.0 -55.0 -5.77053 + 25.0 -55.0 -4.58497 + 30.0 -55.0 -4.27310 + 35.0 -55.0 -3.50768 + 40.0 -55.0 -2.82422 + 45.0 -55.0 -2.23000 + 50.0 -55.0 -1.76833 + 55.0 -55.0 -2.11792 + 60.0 -55.0 -2.49304 + 65.0 -55.0 -3.18409 + 70.0 -55.0 -4.13432 + -70.0 -50.0 0.00000 + -65.0 -50.0 0.00000 + -60.0 -50.0 0.00000 + -55.0 -50.0 0.00000 + -50.0 -50.0 0.00000 + -45.0 -50.0 0.00000 + -40.0 -50.0 0.00000 + -35.0 -50.0 0.00000 + -30.0 -50.0 0.00000 + -25.0 -50.0 0.00000 + -20.0 -50.0 0.00000 + -15.0 -50.0 0.00000 + -10.0 -50.0 0.00000 + -5.0 -50.0 0.00000 + 0.0 -50.0 0.00000 + 5.0 -50.0 0.00000 + 10.0 -50.0 -6.63863 + 15.0 -50.0 -5.33311 + 20.0 -50.0 -4.01857 + 25.0 -50.0 -3.66736 + 30.0 -50.0 -2.90722 + 35.0 -50.0 -2.21066 + 40.0 -50.0 -1.68448 + 45.0 -50.0 -1.38721 + 50.0 -50.0 -1.36080 + 55.0 -50.0 -1.62739 + 60.0 -50.0 -2.23468 + 65.0 -50.0 -3.13091 + 70.0 -50.0 -5.80094 + -70.0 -45.0 0.00000 + -65.0 -45.0 0.00000 + -60.0 -45.0 0.00000 + -55.0 -45.0 0.00000 + -50.0 -45.0 0.00000 + -45.0 -45.0 0.00000 + -40.0 -45.0 0.00000 + -35.0 -45.0 0.00000 + -30.0 -45.0 0.00000 + -25.0 -45.0 0.00000 + -20.0 -45.0 0.00000 + -15.0 -45.0 0.00000 + -10.0 -45.0 0.00000 + -5.0 -45.0 0.00000 + 0.0 -45.0 0.00000 + 5.0 -45.0 -6.53327 + 10.0 -45.0 -5.02271 + 15.0 -45.0 -3.94076 + 20.0 -45.0 -3.09929 + 25.0 -45.0 -2.34721 + 30.0 -45.0 -1.65917 + 35.0 -45.0 -1.12082 + 40.0 -45.0 -0.79028 + 45.0 -45.0 -0.70157 + 50.0 -45.0 -0.90802 + 55.0 -45.0 -1.42864 + 60.0 -45.0 -2.25070 + 65.0 -45.0 -4.90137 + 70.0 -45.0 -5.93459 + -70.0 -40.0 0.00000 + -65.0 -40.0 0.00000 + -60.0 -40.0 0.00000 + -55.0 -40.0 0.00000 + -50.0 -40.0 0.00000 + -45.0 -40.0 0.00000 + -40.0 -40.0 0.00000 + -35.0 -40.0 0.00000 + -30.0 -40.0 0.00000 + -25.0 -40.0 0.00000 + -20.0 -40.0 0.00000 + -15.0 -40.0 0.00000 + -10.0 -40.0 0.00000 + -5.0 -40.0 0.00000 + 0.0 -40.0 -6.57010 + 5.0 -40.0 -4.85677 + 10.0 -40.0 -3.51679 + 15.0 -40.0 -2.58296 + 20.0 -40.0 -1.83150 + 25.0 -40.0 -1.17330 + 30.0 -40.0 -0.65391 + 35.0 -40.0 -0.32513 + 40.0 -40.0 -0.20571 + 45.0 -40.0 -0.34046 + 50.0 -40.0 -0.78406 + 55.0 -40.0 -1.52417 + 60.0 -40.0 -4.13678 + 65.0 -40.0 -5.12874 + 70.0 -40.0 -6.05144 + -70.0 -35.0 0.00000 + -65.0 -35.0 0.00000 + -60.0 -35.0 0.00000 + -55.0 -35.0 0.00000 + -50.0 -35.0 0.00000 + -45.0 -35.0 0.00000 + -40.0 -35.0 0.00000 + -35.0 -35.0 0.00000 + -30.0 -35.0 0.00000 + -25.0 -35.0 0.00000 + -20.0 -35.0 0.00000 + -15.0 -35.0 0.00000 + -10.0 -35.0 0.00000 + -5.0 -35.0 -5.92597 + 0.0 -35.0 -4.28474 + 5.0 -35.0 -3.10799 + 10.0 -35.0 -2.21135 + 15.0 -35.0 -1.42741 + 20.0 -35.0 -0.64595 + 25.0 -35.0 -0.29372 + 30.0 -35.0 0.00003 + 35.0 -35.0 0.11975 + 40.0 -35.0 0.03635 + 45.0 -35.0 -0.31371 + 50.0 -35.0 -2.64356 + 55.0 -35.0 -3.52846 + 60.0 -35.0 -4.46306 + 65.0 -35.0 -5.34103 + 70.0 -35.0 0.00000 + -70.0 -30.0 0.00000 + -65.0 -30.0 0.00000 + -60.0 -30.0 0.00000 + -55.0 -30.0 0.00000 + -50.0 -30.0 0.00000 + -45.0 -30.0 0.00000 + -40.0 -30.0 0.00000 + -35.0 -30.0 0.00000 + -30.0 -30.0 0.00000 + -25.0 -30.0 0.00000 + -20.0 -30.0 0.00000 + -15.0 -30.0 0.00000 + -10.0 -30.0 -6.18732 + -5.0 -30.0 -4.33024 + 0.0 -30.0 -2.97991 + 5.0 -30.0 -2.01487 + 10.0 -30.0 -1.25931 + 15.0 -30.0 -0.57405 + 20.0 -30.0 0.09426 + 25.0 -30.0 0.68688 + 30.0 -30.0 1.12459 + 35.0 -30.0 0.21522 + 40.0 -30.0 -0.04841 + 45.0 -30.0 -2.27904 + 50.0 -30.0 -3.06717 + 55.0 -30.0 -3.94939 + 60.0 -30.0 -4.77338 + 65.0 -30.0 -5.45974 + 70.0 -30.0 0.00000 + -70.0 -25.0 0.00000 + -65.0 -25.0 0.00000 + -60.0 -25.0 0.00000 + -55.0 -25.0 0.00000 + -50.0 -25.0 0.00000 + -45.0 -25.0 0.00000 + -40.0 -25.0 0.00000 + -35.0 -25.0 0.00000 + -30.0 -25.0 0.00000 + -25.0 -25.0 0.00000 + -20.0 -25.0 0.00000 + -15.0 -25.0 -6.27880 + -10.0 -25.0 -4.25795 + -5.0 -25.0 -2.77748 + 0.0 -25.0 -1.72731 + 5.0 -25.0 -0.96655 + 10.0 -25.0 -0.36181 + 15.0 -25.0 0.17451 + 20.0 -25.0 0.63745 + 25.0 -25.0 0.99080 + 30.0 -25.0 1.18756 + 35.0 -25.0 1.14534 + 40.0 -25.0 -2.12832 + 45.0 -25.0 -2.79778 + 50.0 -25.0 -3.62068 + 55.0 -25.0 -4.39808 + 60.0 -25.0 -5.04811 + 65.0 -25.0 0.00000 + 70.0 -25.0 0.00000 + -70.0 -20.0 0.00000 + -65.0 -20.0 0.00000 + -60.0 -20.0 0.00000 + -55.0 -20.0 0.00000 + -50.0 -20.0 0.00000 + -45.0 -20.0 0.00000 + -40.0 -20.0 0.00000 + -35.0 -20.0 0.00000 + -30.0 -20.0 0.00000 + -25.0 -20.0 0.00000 + -20.0 -20.0 -6.10507 + -15.0 -20.0 -4.04626 + -10.0 -20.0 -2.47750 + -5.0 -20.0 -1.34320 + 0.0 -20.0 -0.54524 + 5.0 -20.0 0.02944 + 10.0 -20.0 0.46942 + 15.0 -20.0 0.78831 + 20.0 -20.0 0.98803 + 25.0 -20.0 1.07721 + 30.0 -20.0 1.00084 + 35.0 -20.0 -1.17098 + 40.0 -20.0 -1.76994 + 45.0 -20.0 -2.54277 + 50.0 -20.0 -3.36407 + 55.0 -20.0 -4.95296 + 60.0 -20.0 0.00000 + 65.0 -20.0 0.00000 + 70.0 -20.0 0.00000 + -70.0 -15.0 0.00000 + -65.0 -15.0 0.00000 + -60.0 -15.0 0.00000 + -55.0 -15.0 0.00000 + -50.0 -15.0 0.00000 + -45.0 -15.0 0.00000 + -40.0 -15.0 0.00000 + -35.0 -15.0 0.00000 + -30.0 -15.0 0.00000 + -25.0 -15.0 -5.90156 + -20.0 -15.0 -3.81608 + -15.0 -15.0 -2.17103 + -10.0 -15.0 -0.95394 + -5.0 -15.0 -0.10034 + 0.0 -15.0 0.48350 + 5.0 -15.0 0.88117 + 10.0 -15.0 1.11288 + 15.0 -15.0 1.19322 + 20.0 -15.0 1.15473 + 25.0 -15.0 0.97304 + 30.0 -15.0 -1.26660 + 35.0 -15.0 -1.89711 + 40.0 -15.0 -2.68141 + 45.0 -15.0 -3.52549 + 50.0 -15.0 -4.30253 + 55.0 -15.0 0.00000 + 60.0 -15.0 0.00000 + 65.0 -15.0 0.00000 + 70.0 -15.0 0.00000 + -70.0 -10.0 0.00000 + -65.0 -10.0 0.00000 + -60.0 -10.0 0.00000 + -55.0 -10.0 0.00000 + -50.0 -10.0 0.00000 + -45.0 -10.0 0.00000 + -40.0 -10.0 0.00000 + -35.0 -10.0 0.00000 + -30.0 -10.0 -5.70392 + -25.0 -10.0 -3.61717 + -20.0 -10.0 -1.91508 + -15.0 -10.0 -0.62115 + -10.0 -10.0 0.29805 + -5.0 -10.0 0.91473 + 0.0 -10.0 1.30019 + 5.0 -10.0 1.47676 + 10.0 -10.0 1.47446 + 15.0 -10.0 1.34819 + 20.0 -10.0 1.08751 + 25.0 -10.0 -1.22164 + 30.0 -10.0 -1.93977 + 35.0 -10.0 -2.80400 + 40.0 -10.0 -3.72852 + 45.0 -10.0 -4.60080 + 50.0 -10.0 -5.38213 + 55.0 -10.0 0.00000 + 60.0 -10.0 0.00000 + 65.0 -10.0 0.00000 + 70.0 -10.0 0.00000 + -70.0 -5.0 0.00000 + -65.0 -5.0 0.00000 + -60.0 -5.0 0.00000 + -55.0 -5.0 0.00000 + -50.0 -5.0 0.00000 + -45.0 -5.0 0.00000 + -40.0 -5.0 0.00000 + -35.0 -5.0 -5.51729 + -30.0 -5.0 -3.46011 + -25.0 -5.0 -1.72666 + -20.0 -5.0 -0.36810 + -15.0 -5.0 0.62156 + -10.0 -5.0 1.29020 + -5.0 -5.0 1.68773 + 0.0 -5.0 1.83011 + 5.0 -5.0 1.75960 + 10.0 -5.0 1.55830 + 15.0 -5.0 1.23737 + 20.0 -5.0 -1.09827 + 25.0 -5.0 -1.87842 + 30.0 -5.0 -2.83083 + 35.0 -5.0 -3.87572 + 40.0 -5.0 -4.89107 + 45.0 -5.0 -5.82410 + 50.0 -5.0 0.00000 + 55.0 -5.0 0.00000 + 60.0 -5.0 0.00000 + 65.0 -5.0 0.00000 + 70.0 -5.0 0.00000 + -70.0 0.0 0.00000 + -65.0 0.0 0.00000 + -60.0 0.0 0.00000 + -55.0 0.0 0.00000 + -50.0 0.0 0.00000 + -45.0 0.0 0.00000 + -40.0 0.0 -5.34482 + -35.0 0.0 -3.34521 + -30.0 0.0 -1.61137 + -25.0 0.0 -0.20555 + -20.0 0.0 0.85529 + -15.0 0.0 1.59343 + -10.0 0.0 2.02872 + -5.0 0.0 2.15953 + 0.0 0.0 2.03458 + 5.0 0.0 1.76198 + 10.0 0.0 1.38128 + 15.0 0.0 -0.96469 + 20.0 0.0 -1.78660 + 25.0 0.0 -2.79273 + 30.0 0.0 -3.93181 + 35.0 0.0 -5.09715 + 40.0 0.0 -6.21194 + 45.0 0.0 0.00000 + 50.0 0.0 0.00000 + 55.0 0.0 0.00000 + 60.0 0.0 0.00000 + 65.0 0.0 0.00000 + 70.0 0.0 0.00000 + -70.0 5.0 0.00000 + -65.0 5.0 0.00000 + -60.0 5.0 0.00000 + -55.0 5.0 0.00000 + -50.0 5.0 0.00000 + -45.0 5.0 0.00000 + -40.0 5.0 -3.27257 + -35.0 5.0 -1.57286 + -30.0 5.0 -0.14298 + -25.0 5.0 0.98614 + -20.0 5.0 1.80967 + -15.0 5.0 2.31029 + -10.0 5.0 2.45782 + -5.0 5.0 2.30004 + 0.0 5.0 1.96403 + 5.0 5.0 1.51569 + 10.0 5.0 -0.84419 + 15.0 5.0 -1.71212 + 20.0 5.0 -2.75319 + 25.0 5.0 -3.94287 + 30.0 5.0 -5.20826 + 35.0 5.0 -6.48697 + 40.0 5.0 0.00000 + 45.0 5.0 0.00000 + 50.0 5.0 0.00000 + 55.0 5.0 0.00000 + 60.0 5.0 0.00000 + 65.0 5.0 0.00000 + 70.0 5.0 0.00000 + -70.0 10.0 0.00000 + -65.0 10.0 0.00000 + -60.0 10.0 0.00000 + -55.0 10.0 0.00000 + -50.0 10.0 0.00000 + -45.0 10.0 -3.24952 + -40.0 10.0 -1.62165 + -35.0 10.0 -0.19346 + -30.0 10.0 0.99679 + -25.0 10.0 1.91758 + -20.0 10.0 2.50752 + -15.0 10.0 2.69707 + -10.0 10.0 2.50659 + -5.0 10.0 2.17901 + 0.0 10.0 1.13819 + 5.0 10.0 -0.96263 + 10.0 10.0 -1.76686 + 15.0 10.0 -2.77670 + 20.0 10.0 -3.96628 + 25.0 10.0 -5.27174 + 30.0 10.0 -6.65005 + 35.0 10.0 0.00000 + 40.0 10.0 0.00000 + 45.0 10.0 0.00000 + 50.0 10.0 0.00000 + 55.0 10.0 0.00000 + 60.0 10.0 0.00000 + 65.0 10.0 0.00000 + 70.0 10.0 0.00000 + -70.0 15.0 0.00000 + -65.0 15.0 0.00000 + -60.0 15.0 0.00000 + -55.0 15.0 0.00000 + -50.0 15.0 -3.29749 + -45.0 15.0 -1.78406 + -40.0 15.0 -0.38197 + -35.0 15.0 0.86239 + -30.0 15.0 1.88611 + -25.0 15.0 2.45837 + -20.0 15.0 2.44965 + -15.0 15.0 0.90441 + -10.0 15.0 -0.68892 + -5.0 15.0 1.87753 + 0.0 15.0 0.08938 + 5.0 15.0 -2.10699 + 10.0 15.0 -2.96799 + 15.0 15.0 -4.06390 + 20.0 15.0 -5.33599 + 25.0 15.0 -6.74111 + 30.0 15.0 -8.37771 + 35.0 15.0 0.00000 + 40.0 15.0 0.00000 + 45.0 15.0 0.00000 + 50.0 15.0 0.00000 + 55.0 15.0 0.00000 + 60.0 15.0 0.00000 + 65.0 15.0 0.00000 + 70.0 15.0 0.00000 + -70.0 20.0 0.00000 + -65.0 20.0 0.00000 + -60.0 20.0 0.00000 + -55.0 20.0 0.00000 + -50.0 20.0 -2.09312 + -45.0 20.0 -0.74079 + -40.0 20.0 0.54623 + -35.0 20.0 1.64682 + -30.0 20.0 2.01915 + -25.0 20.0 2.03392 + -20.0 20.0 0.76985 + -15.0 20.0 -0.21566 + -10.0 20.0 -1.34093 + -5.0 20.0 -0.74959 + 0.0 20.0 -2.75998 + 5.0 20.0 -3.41103 + 10.0 20.0 -4.31485 + 15.0 20.0 -5.45764 + 20.0 20.0 -6.80536 + 25.0 20.0 -8.44874 + 30.0 20.0 0.00000 + 35.0 20.0 0.00000 + 40.0 20.0 0.00000 + 45.0 20.0 0.00000 + 50.0 20.0 0.00000 + 55.0 20.0 0.00000 + 60.0 20.0 0.00000 + 65.0 20.0 0.00000 + 70.0 20.0 0.00000 + -70.0 25.0 0.00000 + -65.0 25.0 0.00000 + -60.0 25.0 0.00000 + -55.0 25.0 -2.50998 + -50.0 25.0 -1.24688 + -45.0 25.0 0.03352 + -40.0 25.0 0.98432 + -35.0 25.0 1.43676 + -30.0 25.0 1.53155 + -25.0 25.0 0.58122 + -20.0 25.0 -0.44659 + -15.0 25.0 -1.88011 + -10.0 25.0 -3.70037 + -5.0 25.0 -3.59523 + 0.0 25.0 -4.14025 + 5.0 25.0 -4.79070 + 10.0 25.0 -5.70684 + 15.0 25.0 -6.89601 + 20.0 25.0 -6.08390 + 25.0 25.0 0.00000 + 30.0 25.0 0.00000 + 35.0 25.0 0.00000 + 40.0 25.0 0.00000 + 45.0 25.0 0.00000 + 50.0 25.0 0.00000 + 55.0 25.0 0.00000 + 60.0 25.0 0.00000 + 65.0 25.0 0.00000 + 70.0 25.0 0.00000 + -70.0 30.0 0.00000 + -65.0 30.0 0.00000 + -60.0 30.0 0.00000 + -55.0 30.0 -1.80627 + -50.0 30.0 -0.69843 + -45.0 30.0 0.11574 + -40.0 30.0 0.69765 + -35.0 30.0 0.93325 + -30.0 30.0 0.30374 + -25.0 30.0 -0.70409 + -20.0 30.0 -1.76828 + -15.0 30.0 -2.75691 + -10.0 30.0 -5.25511 + -5.0 30.0 -5.13795 + 0.0 30.0 -5.52094 + 5.0 30.0 -3.67938 + 10.0 30.0 -4.64604 + 15.0 30.0 -7.69620 + 20.0 30.0 0.00000 + 25.0 30.0 0.00000 + 30.0 30.0 0.00000 + 35.0 30.0 0.00000 + 40.0 30.0 0.00000 + 45.0 30.0 0.00000 + 50.0 30.0 0.00000 + 55.0 30.0 0.00000 + 60.0 30.0 0.00000 + 65.0 30.0 0.00000 + 70.0 30.0 0.00000 + -70.0 35.0 0.00000 + -65.0 35.0 0.00000 + -60.0 35.0 -2.77392 + -55.0 35.0 -1.82142 + -50.0 35.0 -0.95610 + -45.0 35.0 -0.24184 + -40.0 35.0 0.17605 + -35.0 35.0 -0.11685 + -30.0 35.0 -1.02718 + -25.0 35.0 -2.11567 + -20.0 35.0 -3.07610 + -15.0 35.0 -5.37914 + -10.0 35.0 -6.39156 + -5.0 35.0 -7.26126 + 0.0 35.0 -5.89265 + 5.0 35.0 -6.58388 + 10.0 35.0 0.00000 + 15.0 35.0 0.00000 + 20.0 35.0 0.00000 + 25.0 35.0 0.00000 + 30.0 35.0 0.00000 + 35.0 35.0 0.00000 + 40.0 35.0 0.00000 + 45.0 35.0 0.00000 + 50.0 35.0 0.00000 + 55.0 35.0 0.00000 + 60.0 35.0 0.00000 + 65.0 35.0 0.00000 + 70.0 35.0 0.00000 + -70.0 40.0 0.00000 + -65.0 40.0 0.00000 + -60.0 40.0 -2.96696 + -55.0 40.0 -2.10390 + -50.0 40.0 -1.32419 + -45.0 40.0 -0.76928 + -40.0 40.0 -0.75079 + -35.0 40.0 -1.45827 + -30.0 40.0 -2.48234 + -25.0 40.0 -3.48033 + -20.0 40.0 -6.10713 + -15.0 40.0 -6.57222 + -10.0 40.0 -7.37632 + -5.0 40.0 -6.89430 + 0.0 40.0 -7.20459 + 5.0 40.0 0.00000 + 10.0 40.0 0.00000 + 15.0 40.0 0.00000 + 20.0 40.0 0.00000 + 25.0 40.0 0.00000 + 30.0 40.0 0.00000 + 35.0 40.0 0.00000 + 40.0 40.0 0.00000 + 45.0 40.0 0.00000 + 50.0 40.0 0.00000 + 55.0 40.0 0.00000 + 60.0 40.0 0.00000 + 65.0 40.0 0.00000 + 70.0 40.0 0.00000 + -70.0 45.0 0.00000 + -65.0 45.0 0.00000 + -60.0 45.0 -3.17785 + -55.0 45.0 -2.38888 + -50.0 45.0 -1.77582 + -45.0 45.0 -1.56889 + -40.0 45.0 -2.05470 + -35.0 45.0 -2.85973 + -30.0 45.0 -2.27104 + -25.0 45.0 -6.30839 + -20.0 45.0 -5.25621 + -15.0 45.0 -6.06589 + -10.0 45.0 -6.96252 + -5.0 45.0 -7.80226 + 0.0 45.0 0.00000 + 5.0 45.0 0.00000 + 10.0 45.0 0.00000 + 15.0 45.0 0.00000 + 20.0 45.0 0.00000 + 25.0 45.0 0.00000 + 30.0 45.0 0.00000 + 35.0 45.0 0.00000 + 40.0 45.0 0.00000 + 45.0 45.0 0.00000 + 50.0 45.0 0.00000 + 55.0 45.0 0.00000 + 60.0 45.0 0.00000 + 65.0 45.0 0.00000 + 70.0 45.0 0.00000 + -70.0 50.0 0.00000 + -65.0 50.0 0.00000 + -60.0 50.0 -3.33185 + -55.0 50.0 -2.70030 + -50.0 50.0 -2.38617 + -45.0 50.0 -2.70402 + -40.0 50.0 -3.29104 + -35.0 50.0 -4.48573 + -30.0 50.0 -4.80276 + -25.0 50.0 -5.80677 + -20.0 50.0 -6.02399 + -15.0 50.0 -6.85079 + -10.0 50.0 -7.70991 + -5.0 50.0 0.00000 + 0.0 50.0 0.00000 + 5.0 50.0 0.00000 + 10.0 50.0 0.00000 + 15.0 50.0 0.00000 + 20.0 50.0 0.00000 + 25.0 50.0 0.00000 + 30.0 50.0 0.00000 + 35.0 50.0 0.00000 + 40.0 50.0 0.00000 + 45.0 50.0 0.00000 + 50.0 50.0 0.00000 + 55.0 50.0 0.00000 + 60.0 50.0 0.00000 + 65.0 50.0 0.00000 + 70.0 50.0 0.00000 + -70.0 55.0 0.00000 + -65.0 55.0 0.00000 + -60.0 55.0 -3.47703 + -55.0 55.0 -3.11870 + -50.0 55.0 -3.26172 + -45.0 55.0 -3.69949 + -40.0 55.0 -4.95466 + -35.0 55.0 -5.27716 + -30.0 55.0 -5.52653 + -25.0 55.0 -5.90597 + -20.0 55.0 -6.58543 + -15.0 55.0 0.00000 + -10.0 55.0 0.00000 + -5.0 55.0 0.00000 + 0.0 55.0 0.00000 + 5.0 55.0 0.00000 + 10.0 55.0 0.00000 + 15.0 55.0 0.00000 + 20.0 55.0 0.00000 + 25.0 55.0 0.00000 + 30.0 55.0 0.00000 + 35.0 55.0 0.00000 + 40.0 55.0 0.00000 + 45.0 55.0 0.00000 + 50.0 55.0 0.00000 + 55.0 55.0 0.00000 + 60.0 55.0 0.00000 + 65.0 55.0 0.00000 + 70.0 55.0 0.00000 + -70.0 60.0 0.00000 + -65.0 60.0 0.00000 + -60.0 60.0 0.00000 + -55.0 60.0 -3.69092 + -50.0 60.0 -4.17700 + -45.0 60.0 -5.34644 + -40.0 60.0 -5.54562 + -35.0 60.0 -5.72098 + -30.0 60.0 0.00000 + -25.0 60.0 0.00000 + -20.0 60.0 0.00000 + -15.0 60.0 0.00000 + -10.0 60.0 0.00000 + -5.0 60.0 0.00000 + 0.0 60.0 0.00000 + 5.0 60.0 0.00000 + 10.0 60.0 0.00000 + 15.0 60.0 0.00000 + 20.0 60.0 0.00000 + 25.0 60.0 0.00000 + 30.0 60.0 0.00000 + 35.0 60.0 0.00000 + 40.0 60.0 0.00000 + 45.0 60.0 0.00000 + 50.0 60.0 0.00000 + 55.0 60.0 0.00000 + 60.0 60.0 0.00000 + 65.0 60.0 0.00000 + 70.0 60.0 0.00000 + -70.0 65.0 0.00000 + -65.0 65.0 0.00000 + -60.0 65.0 0.00000 + -55.0 65.0 0.00000 + -50.0 65.0 0.00000 + -45.0 65.0 0.00000 + -40.0 65.0 0.00000 + -35.0 65.0 0.00000 + -30.0 65.0 0.00000 + -25.0 65.0 0.00000 + -20.0 65.0 0.00000 + -15.0 65.0 0.00000 + -10.0 65.0 0.00000 + -5.0 65.0 0.00000 + 0.0 65.0 0.00000 + 5.0 65.0 0.00000 + 10.0 65.0 0.00000 + 15.0 65.0 0.00000 + 20.0 65.0 0.00000 + 25.0 65.0 0.00000 + 30.0 65.0 0.00000 + 35.0 65.0 0.00000 + 40.0 65.0 0.00000 + 45.0 65.0 0.00000 + 50.0 65.0 0.00000 + 55.0 65.0 0.00000 + 60.0 65.0 0.00000 + 65.0 65.0 0.00000 + 70.0 65.0 0.00000 + -70.0 70.0 0.00000 + -65.0 70.0 0.00000 + -60.0 70.0 0.00000 + -55.0 70.0 0.00000 + -50.0 70.0 0.00000 + -45.0 70.0 0.00000 + -40.0 70.0 0.00000 + -35.0 70.0 0.00000 + -30.0 70.0 0.00000 + -25.0 70.0 0.00000 + -20.0 70.0 0.00000 + -15.0 70.0 0.00000 + -10.0 70.0 0.00000 + -5.0 70.0 0.00000 + 0.0 70.0 0.00000 + 5.0 70.0 0.00000 + 10.0 70.0 0.00000 + 15.0 70.0 0.00000 + 20.0 70.0 0.00000 + 25.0 70.0 0.00000 + 30.0 70.0 0.00000 + 35.0 70.0 0.00000 + 40.0 70.0 0.00000 + 45.0 70.0 0.00000 + 50.0 70.0 0.00000 + 55.0 70.0 0.00000 + 60.0 70.0 0.00000 + 65.0 70.0 0.00000 + 70.0 70.0 0.00000 + + + ################################### + ## ## + ## Atomic Multipole Parameters ## + ## ## + ################################### + + +multipole 1 2 4 -0.22620 + 0.08214 0.00000 0.34883 + 0.11775 + 0.00000 -1.02185 + -0.17555 0.00000 0.90410 +multipole 2 1 3 -0.15245 + 0.19517 0.00000 0.19687 + -0.20677 + 0.00000 -0.48084 + -0.01672 0.00000 0.68761 +multipole 2 1 238 -0.26188 + 0.19517 0.00000 0.19687 + -0.20677 + 0.00000 -0.48084 + -0.01672 0.00000 0.68761 +multipole 2 1 240 -0.06378 + 0.23312 0.13956 0.09887 + -0.31660 + -0.24134 -0.22704 + 0.00987 -0.17429 0.54364 +multipole 2 234 3 -0.00060 + 0.19517 0.00000 0.19687 + -0.20677 + 0.00000 -0.48084 + -0.01672 0.00000 0.68761 +multipole 2 236 3 -0.15431 + 0.17831 0.12028 0.04835 + -0.18716 + -0.14669 -0.30278 + -0.23445 -0.03639 0.48994 +multipole 3 5 2 0.84374 + -0.10331 0.00000 0.21864 + 0.12993 + 0.00000 -0.31823 + 0.00297 0.00000 0.18830 +multipole 4 1 2 0.12752 + 0.00647 0.00000 -0.12783 + 0.03203 + 0.00000 -0.02425 + -0.00668 0.00000 -0.00778 +multipole 5 3 2 -0.73597 + -0.00206 0.00000 -0.19382 + -0.52873 + 0.00000 0.31757 + 0.01718 0.00000 0.21116 +multipole 6 2 6 0.07168 + -0.00670 0.00000 -0.03554 + -0.01145 + 0.00000 0.00424 + 0.00006 0.00000 0.00721 +multipole 7 8 10 -0.14985 + 0.03550 0.00000 0.44301 + 0.09170 + 0.00000 -1.11491 + -0.24348 0.00000 1.02321 +multipole 7 33 10 -0.07700 + 0.07153 0.00000 0.47356 + 0.04187 + 0.00000 -1.12615 + -0.13307 0.00000 1.08428 +multipole 7 44 10 -0.14168 + 0.07684 0.00000 0.42468 + 0.07677 + 0.00000 -1.10639 + -0.13195 0.00000 1.02962 +multipole 8 7 9 12 -0.21238 + 0.15677 0.10446 0.14545 + -0.17425 + -0.22519 -0.40549 + -0.00044 -0.22429 0.57974 +multipole 8 7 238 12 -0.35660 + 0.15677 0.10446 0.14545 + -0.17425 + -0.22519 -0.40549 + -0.00044 -0.22429 0.57974 +multipole 8 7 240 12 -0.15850 + 0.23312 0.13956 0.09887 + -0.31660 + -0.24134 -0.22704 + 0.00987 -0.17429 0.54364 +multipole 8 234 9 12 0.01822 + 0.16474 0.12633 0.26753 + -0.21185 + -0.16278 -0.28684 + -0.20823 -0.06352 0.49869 +multipole 8 236 9 12 -0.13549 + 0.17831 0.12028 0.04835 + -0.18716 + -0.14669 -0.30278 + -0.23445 -0.03639 0.48994 +multipole 9 11 8 0.85068 + -0.01685 0.00000 0.27745 + 0.29463 + 0.00000 -0.41598 + -0.00743 0.00000 0.12135 +multipole 9 11 33 0.86830 + -0.00831 0.00000 0.28673 + 0.31013 + 0.00000 -0.40744 + -0.02007 0.00000 0.09731 +multipole 9 11 44 0.86623 + -0.01620 0.00000 0.28155 + 0.21345 + 0.00000 -0.37126 + 0.03757 0.00000 0.15781 +multipole 10 7 8 0.12992 + -0.00883 0.00000 -0.14169 + 0.04124 + 0.00000 -0.02603 + -0.00466 0.00000 -0.01521 +multipole 10 7 33 0.13014 + -0.01463 0.00000 -0.14527 + 0.04339 + 0.00000 -0.02611 + -0.00341 0.00000 -0.01728 +multipole 10 7 44 0.13192 + -0.02608 0.00000 -0.13150 + 0.02396 + 0.00000 -0.01254 + 0.00671 0.00000 -0.01142 +multipole 11 9 8 -0.77770 + -0.01897 0.00000 -0.21786 + -0.61542 + 0.00000 0.33936 + 0.00866 0.00000 0.27606 +multipole 11 9 33 -0.78568 + -0.00475 0.00000 -0.21642 + -0.63353 + 0.00000 0.34214 + 0.02232 0.00000 0.29139 +multipole 11 9 44 -0.77214 + -0.00136 0.00000 -0.21318 + -0.59230 + 0.00000 0.31639 + 0.01541 0.00000 0.27591 +multipole 12 8 13 0.08921 + 0.01405 0.00000 0.04185 + -0.00099 + 0.00000 -0.00099 + 0.00801 0.00000 0.00198 +multipole 12 8 15 0.08921 + 0.01405 0.00000 0.04185 + -0.00099 + 0.00000 -0.00099 + 0.00801 0.00000 0.00198 +multipole 12 8 19 0.08921 + 0.01405 0.00000 0.04185 + -0.00099 + 0.00000 -0.00099 + 0.00801 0.00000 0.00198 +multipole 12 8 25 0.08921 + 0.01405 0.00000 0.04185 + -0.00099 + 0.00000 -0.00099 + 0.00801 0.00000 0.00198 +multipole 12 8 64 0.08921 + 0.01405 0.00000 0.04185 + -0.00099 + 0.00000 -0.00099 + 0.00801 0.00000 0.00198 +multipole 12 8 73 0.08921 + 0.01405 0.00000 0.04185 + -0.00099 + 0.00000 -0.00099 + 0.00801 0.00000 0.00198 +multipole 12 8 92 0.08921 + 0.01405 0.00000 0.04185 + -0.00099 + 0.00000 -0.00099 + 0.00801 0.00000 0.00198 +multipole 12 8 109 0.08921 + 0.01405 0.00000 0.04185 + -0.00099 + 0.00000 -0.00099 + 0.00801 0.00000 0.00198 +multipole 12 8 120 0.08921 + 0.01405 0.00000 0.04185 + -0.00099 + 0.00000 -0.00099 + 0.00801 0.00000 0.00198 +multipole 12 8 130 0.08921 + 0.01405 0.00000 0.04185 + -0.00099 + 0.00000 -0.00099 + 0.00801 0.00000 0.00198 +multipole 12 8 140 0.08921 + 0.01405 0.00000 0.04185 + -0.00099 + 0.00000 -0.00099 + 0.00801 0.00000 0.00198 +multipole 12 8 144 0.08921 + 0.01405 0.00000 0.04185 + -0.00099 + 0.00000 -0.00099 + 0.00801 0.00000 0.00198 +multipole 12 8 150 0.08921 + 0.01405 0.00000 0.04185 + -0.00099 + 0.00000 -0.00099 + 0.00801 0.00000 0.00198 +multipole 12 8 156 0.08921 + 0.01405 0.00000 0.04185 + -0.00099 + 0.00000 -0.00099 + 0.00801 0.00000 0.00198 +multipole 12 8 170 0.08921 + 0.01405 0.00000 0.04185 + -0.00099 + 0.00000 -0.00099 + 0.00801 0.00000 0.00198 +multipole 12 8 178 0.08921 + 0.01405 0.00000 0.04185 + -0.00099 + 0.00000 -0.00099 + 0.00801 0.00000 0.00198 +multipole 12 8 185 0.08921 + 0.01405 0.00000 0.04185 + -0.00099 + 0.00000 -0.00099 + 0.00801 0.00000 0.00198 +multipole 12 8 195 0.08921 + 0.01405 0.00000 0.04185 + -0.00099 + 0.00000 -0.00099 + 0.00801 0.00000 0.00198 +multipole 12 8 205 0.08921 + 0.01405 0.00000 0.04185 + -0.00099 + 0.00000 -0.00099 + 0.00801 0.00000 0.00198 +multipole 12 8 216 0.08921 + 0.01405 0.00000 0.04185 + -0.00099 + 0.00000 -0.00099 + 0.00801 0.00000 0.00198 +multipole 12 8 83 0.08544 + 0.00588 0.00000 0.05950 + 0.02355 + 0.00000 -0.01645 + 0.01114 0.00000 -0.00710 +multipole 12 8 162 0.08646 + 0.00138 0.00000 0.00677 + -0.00925 + 0.00000 0.00263 + 0.01278 0.00000 0.00662 +multipole 12 33 34 0.09030 + 0.00560 0.00000 0.05742 + -0.00170 + 0.00000 0.00174 + 0.01050 0.00000 -0.00004 +multipole 12 33 38 0.08972 + -0.00888 0.00000 0.07916 + -0.01768 + 0.00000 -0.01918 + -0.00214 0.00000 0.03686 +multipole 12 44 45 0.09885 + 0.01622 0.00000 0.05792 + 0.00647 + 0.00000 0.00221 + 0.01141 0.00000 -0.00868 +multipole 12 44 50 0.09273 + -0.01562 0.00000 0.07350 + -0.08566 + 0.00000 0.06242 + 0.09474 0.00000 0.02324 +multipole 13 8 12 -0.15440 + -0.00010 0.00000 0.36287 + -0.29475 + 0.00000 -0.29287 + 0.00762 0.00000 0.58762 +multipole 14 13 8 0.07484 + -0.00111 0.00000 -0.10010 + -0.00304 + 0.00000 -0.01538 + 0.01240 0.00000 0.01842 +multipole 15 16 8 0.01482 + 0.08020 0.00000 -0.26997 + 0.34033 + 0.00000 0.14255 + -0.02494 0.00000 -0.48288 +multipole 16 15 8 0.06618 + -0.01550 0.00000 -0.03799 + -0.02092 + 0.00000 -0.00865 + 0.00210 0.00000 0.02957 +multipole 17 15 8 -0.17773 + 0.01639 0.00000 0.27595 + -0.26651 + 0.00000 -0.24157 + -0.00302 0.00000 0.50808 +multipole 18 17 15 0.05743 + 0.00260 0.00000 -0.09807 + -0.00994 + 0.00118 -0.01956 + 0.00000 0.00000 0.02950 +multipole 19 8 21 -0.05880 + 0.26546 0.00000 0.21223 + 0.20945 + 0.00000 -0.58569 + -0.11242 0.00000 0.37624 +multipole 21 22 19 0.02425 + 0.13818 0.00000 -0.10780 + 0.34224 + 0.00000 0.03484 + -0.07137 0.00000 -0.37708 +multipole 23 21 19 -0.11850 + 0.02042 0.00000 0.27842 + -0.21793 + 0.00000 -0.21279 + -0.05341 0.00000 0.43072 +multipole 20 19 21 0.04696 + 0.00607 0.00000 -0.06684 + -0.06962 + 0.00000 -0.00388 + 0.07593 0.00000 0.07350 +multipole 22 21 19 0.00841 + -0.00672 0.00000 -0.06533 + -0.02250 + 0.00000 -0.00022 + 0.02359 0.00000 0.02272 +multipole 24 23 21 0.03989 + -0.00280 0.00000 -0.10039 + 0.04169 + 0.00000 0.04396 + -0.04893 0.00000 -0.08565 +multipole 25 26 29 0.02186 + 0.08020 0.00000 -0.26997 + 0.34033 + 0.00000 0.14255 + -0.02494 0.00000 -0.48288 +multipole 26 25 29 0.06618 + -0.01550 0.00000 -0.03799 + -0.02092 + 0.00000 -0.00865 + 0.00210 0.00000 0.02957 +multipole 27 25 29 -0.17773 + 0.01639 0.00000 0.27595 + -0.26651 + 0.00000 -0.24157 + -0.00302 0.00000 0.50808 +multipole 28 27 25 0.05743 + 0.00260 0.00000 -0.09807 + -0.00994 + 0.00118 -0.01956 + 0.00000 0.00000 0.02950 +multipole 29 31 25 -0.13782 + 0.30388 0.00000 0.06758 + 0.23297 + 0.00000 -0.52767 + -0.19079 0.00000 0.29470 +multipole 30 29 25 0.05838 + -0.00859 0.00000 -0.06224 + -0.01816 + 0.00000 -0.01607 + 0.00914 0.00000 0.03423 +multipole 31 29 32 -0.16689 + 0.00000 0.00000 0.21012 + -0.26816 + 0.00000 -0.20521 + 0.00830 0.00000 0.47337 +multipole 32 31 29 0.05849 + 0.01309 0.00000 -0.10315 + -0.00194 + 0.00000 -0.01929 + 0.00780 0.00000 0.02123 +multipole 33 7 9 12 -0.31424 + 0.10978 0.18667 0.05863 + -0.13616 + -0.31125 -0.33777 + 0.02536 -0.27378 0.47393 +multipole 33 7 238 12 -0.44882 + 0.10978 0.18667 0.05863 + -0.13616 + -0.31125 -0.33777 + 0.02536 -0.27378 0.47393 +multipole 33 234 9 12 -0.01057 + 0.10978 0.18667 0.25863 + -0.13616 + -0.31125 -0.33777 + 0.02536 -0.27378 0.47393 +multipole 33 236 9 12 -0.16428 + 0.17831 0.12028 0.04835 + -0.18716 + -0.14669 -0.30278 + -0.23445 -0.03639 0.48994 +multipole 34 33 36 0.18740 + 0.32652 0.00000 0.16904 + 0.38884 + 0.00000 -0.64696 + -0.40264 0.00000 0.25812 +multipole 35 34 33 0.01982 + -0.01239 0.00000 -0.11747 + 0.01971 + 0.00000 0.00381 + -0.01013 0.00000 -0.02352 +multipole 36 37 34 -0.41295 + 0.33448 0.00000 -0.14251 + 0.42448 + 0.00000 -0.41234 + -0.38297 0.00000 -0.01214 +multipole 37 36 34 0.27409 + -0.00229 0.00000 -0.14154 + 0.03579 + 0.00000 -0.00191 + 0.07686 0.00000 -0.03388 +multipole 38 42 33 0.17854 + 0.23880 0.00000 0.32060 + 0.10533 + 0.00000 -0.64403 + -0.29222 0.00000 0.53870 +multipole 39 38 42 0.02134 + -0.00950 0.00000 -0.09928 + 0.00686 + 0.00000 0.00614 + 0.05736 0.00000 -0.01300 +multipole 40 38 41 -0.15307 + -0.00025 0.00000 0.38046 + -0.30173 + 0.00000 -0.22953 + -0.06348 0.00000 0.53126 +multipole 41 40 38 0.07192 + -0.00679 0.00000 -0.10053 + 0.06651 + 0.00000 0.02229 + -0.00281 0.00000 -0.08880 +multipole 42 43 38 -0.39938 + 0.31891 0.00000 0.06162 + 0.17801 + 0.00000 -0.65478 + -0.34887 0.00000 0.47677 +multipole 43 42 38 0.22557 + -0.05057 0.00000 -0.02631 + -0.03639 + 0.00000 -0.07964 + -0.03676 0.00000 0.11603 +multipole 44 7 9 12 -0.24710 + 0.10958 0.20789 0.11165 + -0.29651 + -0.34984 -0.19439 + 0.01482 -0.12065 0.49090 +multipole 44 7 238 12 -0.37021 + 0.10958 0.20789 0.11165 + -0.29651 + -0.34984 -0.19439 + 0.01482 -0.12065 0.49090 +multipole 44 234 9 12 -0.00633 + 0.10958 0.20789 0.25165 + -0.29651 + -0.34984 -0.19439 + 0.01482 -0.12065 0.49090 +multipole 44 236 9 12 -0.16004 + 0.17831 0.12028 0.04835 + -0.18716 + -0.14669 -0.30278 + -0.23445 -0.03639 0.48994 +multipole 45 44 47 -0.15207 + -0.06553 0.00000 0.34254 + -0.30415 + 0.00000 -0.21377 + -0.28927 0.00000 0.51792 +multipole 45 44 49 -0.15207 + -0.06553 0.00000 0.34254 + -0.30415 + 0.00000 -0.21377 + -0.28927 0.00000 0.51792 +multipole 46 45 44 0.07591 + -0.00889 0.00000 -0.04092 + -0.18958 + 0.00000 0.00422 + 0.16671 0.00000 0.18536 +multipole 47 48 45 -0.04712 + 0.52591 0.00000 -0.09604 + 1.70327 + 0.00000 -2.34352 + -0.60679 0.00000 0.64025 +multipole 48 47 45 0.11129 + -0.04992 0.00000 -0.08691 + 0.05295 + 0.00000 0.13423 + -0.05345 0.00000 -0.18718 +multipole 49 49 45 0.06417 + 0.53667 0.00000 0.23589 + 1.30986 + 0.00000 -2.63022 + -0.81921 0.00000 1.32036 +multipole 50 44 52 0.02101 + 0.45179 0.00000 0.06973 + 0.09122 + 0.00000 -0.44012 + -0.52228 0.00000 0.34890 +multipole 51 50 51 0.00952 + -0.01257 0.00000 -0.06988 + 0.12020 + 0.00000 -0.04321 + 0.05399 0.00000 -0.07699 +multipole 52 50 44 -0.97001 + 0.10382 0.00000 0.32906 + -1.26053 + 0.00000 -1.49518 + -0.38944 0.00000 2.75571 +multipole 53 54 62 -0.11893 + 0.34044 0.00000 0.34525 + 0.13454 + 0.00000 -1.26831 + -0.55465 0.00000 1.13377 +multipole 54 53 55 57 -0.38385 + 0.09303 0.30388 0.20804 + -0.28513 + -0.11620 -0.19141 + -0.06760 -0.05551 0.47654 +multipole 54 53 238 57 -0.44047 + 0.09303 0.30388 0.20804 + -0.28513 + -0.11620 -0.19141 + -0.06760 -0.05551 0.47654 +multipole 55 56 54 0.98874 + 0.02791 0.00000 0.30666 + 0.30672 + 0.00000 -0.48397 + 0.08782 0.00000 0.17725 +multipole 56 55 54 -0.82816 + -0.06750 0.00000 -0.25032 + -0.71170 + 0.00000 0.39860 + -0.05460 0.00000 0.31310 +multipole 57 54 58 0.10715 + 0.00609 0.00000 0.07519 + 0.01670 + 0.00000 -0.01648 + 0.01130 0.00000 -0.00022 +multipole 58 54 60 -0.09495 + 0.31121 0.00000 0.40605 + 0.22917 + 0.00000 -0.67119 + -0.07599 0.00000 0.44202 +multipole 58 246 60 -0.12680 + 0.31318 0.00000 0.41341 + 0.26389 + 0.00000 -0.70262 + -0.10425 0.00000 0.43873 +multipole 59 58 54 0.09275 + -0.01264 0.00000 -0.07572 + 0.00128 + 0.00000 -0.02196 + 0.00991 0.00000 0.02068 +multipole 59 58 246 0.11510 + 0.00090 0.00000 -0.07548 + -0.00989 + 0.00000 -0.01502 + 0.00444 0.00000 0.02491 +multipole 60 58 62 -0.11624 + 0.39225 0.00000 0.24210 + 0.33605 + 0.00000 -0.65320 + -0.03333 0.00000 0.31715 +multipole 60 58 250 -0.14420 + 0.42355 0.00000 0.25235 + 0.34755 + 0.00000 -0.69761 + -0.08434 0.00000 0.35006 +multipole 61 60 58 0.09217 + -0.00152 0.00000 -0.07154 + -0.00810 + 0.00000 -0.00700 + 0.00227 0.00000 0.01510 +multipole 61 60 250 0.12121 + -0.00270 0.00000 -0.06030 + -0.00918 + 0.00000 -0.01098 + 0.00194 0.00000 0.02016 +multipole 62 53 60 -0.02016 + 0.15944 0.00000 0.38838 + -0.01606 + 0.00000 -0.54997 + -0.05844 0.00000 0.56603 +multipole 63 62 53 0.04828 + -0.02837 0.00000 -0.10489 + -0.01200 + 0.00000 0.00934 + -0.02136 0.00000 0.00266 +multipole 64 66 8 -0.01895 + 0.36956 0.00000 0.01114 + 0.41183 + 0.00000 -0.66411 + -0.32852 0.00000 0.25228 +multipole 65 64 66 0.06839 + 0.02787 0.00000 -0.13883 + -0.00869 + 0.00000 0.08416 + 0.09373 0.00000 -0.07547 +multipole 66 64 67 -0.06275 + -0.01515 0.00000 0.11717 + 0.10484 + 0.00000 -0.26909 + 0.00249 0.00000 0.16425 +multipole 67 66 69 0.00890 + 0.18546 0.00000 0.15071 + 0.47473 + 0.00000 -0.42840 + 0.28711 0.00000 -0.04633 +multipole 68 67 66 0.02818 + -0.01325 0.00000 -0.14859 + 0.07601 + 0.00000 0.09693 + 0.01121 0.00000 -0.17294 +multipole 69 67 71 -0.05402 + -0.00945 0.00000 0.02922 + -0.00276 + 0.00000 -0.13432 + -0.13875 0.00000 0.13708 +multipole 70 69 67 0.03565 + 0.00481 0.00000 -0.15153 + 0.05398 + 0.00000 0.03814 + 0.00344 0.00000 -0.09212 +multipole 71 69 69 -0.05826 + -0.00098 0.00000 0.01245 + -0.03242 + 0.00000 -0.17444 + -0.15165 0.00000 0.20686 +multipole 72 71 69 0.03588 + 0.00392 0.00000 -0.14928 + 0.04809 + 0.00000 0.01292 + 0.01455 0.00000 -0.06101 +multipole 73 75 8 -0.08206 + 0.35542 0.00000 0.06495 + 0.41791 + 0.00000 -0.63807 + -0.16042 0.00000 0.22016 +multipole 74 73 75 0.09740 + 0.02115 0.00000 -0.06112 + 0.00978 + 0.00000 -0.01888 + 0.05469 0.00000 0.00910 +multipole 75 73 76 -0.04596 + 0.07761 0.00000 0.13512 + 0.00091 + 0.00000 -0.42529 + -0.06469 0.00000 0.42438 +multipole 76 75 78 0.05037 + 0.23670 0.00000 0.14269 + 0.58628 + 0.00000 -0.49067 + 0.35910 0.00000 -0.09561 +multipole 77 76 75 0.01064 + -0.00997 0.00000 -0.17138 + 0.10326 + 0.00000 0.09710 + 0.00429 0.00000 -0.20036 +multipole 78 76 80 -0.12462 + -0.10481 0.00000 -0.00347 + 0.00581 + 0.00000 -0.19007 + -0.11755 0.00000 0.18426 +multipole 79 78 76 0.01162 + 0.02013 0.00000 -0.18305 + 0.05115 + 0.00000 0.05109 + -0.00250 0.00000 -0.10224 +multipole 80 81 78 0.34249 + -0.01127 0.00000 0.41324 + -0.24130 + 0.00000 -0.40041 + 0.28837 0.00000 0.64171 +multipole 81 80 82 -0.46444 + 0.19999 0.00000 0.00411 + 0.31111 + 0.00000 -0.30294 + -0.24184 0.00000 -0.00817 +multipole 82 81 80 0.22927 + -0.06046 0.00000 -0.00959 + -0.06728 + 0.00000 -0.09125 + 0.00623 0.00000 0.15853 +multipole 83 8 85 -0.14811 + 0.11344 0.00000 0.39909 + 0.03628 + 0.00000 -0.47377 + 0.02261 0.00000 0.43749 +multipole 84 83 84 0.08044 + 0.01404 0.00000 -0.09182 + 0.04405 + 0.00000 0.01752 + 0.03456 0.00000 -0.06157 +multipole 85 83 86 -0.21500 + 0.00000 0.00000 0.19889 + 0.43753 + 0.00000 -0.84736 + 0.00000 0.00000 0.40983 +multipole 86 85 88 -0.04459 + 0.32216 0.00000 0.13839 + 0.73596 + 0.00000 -0.60409 + 0.25285 0.00000 -0.13187 +multipole 87 86 85 0.01849 + -0.02121 0.00000 -0.10542 + 0.08078 + 0.00000 0.10479 + -0.00935 0.00000 -0.18557 +multipole 88 86 90 -0.15802 + 0.03729 0.00000 0.15665 + 0.59432 + 0.00000 -0.78857 + 0.29227 0.00000 0.19425 +multipole 89 88 90 -0.03234 + 0.03781 0.00000 -0.15021 + 0.16274 + 0.00000 0.11972 + 0.03565 0.00000 -0.28246 +multipole 90 91 88 0.62054 + 0.00000 0.00000 0.43281 + 0.41363 + 0.00000 -0.34255 + 0.00000 0.00000 -0.07108 +multipole 91 90 88 -0.91150 + 0.00000 0.00000 -0.26161 + -0.27372 + 0.00000 0.34305 + 0.00000 0.00000 -0.06933 +multipole 92 8 94 -0.16392 + -0.01358 0.00000 0.40504 + -0.28121 + 0.00000 -0.40534 + 0.19195 0.00000 0.68655 +multipole 93 92 94 0.09307 + 0.02678 0.00000 -0.03143 + 0.01097 + 0.00000 -0.00954 + 0.00302 0.00000 -0.00143 +multipole 94 95 97 -0.10518 + -0.33769 0.00000 -0.13606 + 0.08389 + 0.00000 -0.32705 + 0.64420 0.00000 0.24316 +multipole 95 98 94 0.06363 + 0.00315 0.00000 0.45577 + -0.13664 + 0.00000 -0.45223 + 0.50170 0.00000 0.58887 +multipole 96 95 98 0.02858 + -0.00357 0.00000 -0.19861 + 0.04841 + 0.00000 0.04990 + -0.01000 0.00000 -0.09831 +multipole 97 94 101 0.00670 + 0.26019 0.00000 -0.05143 + 0.25420 + 0.00000 -0.02804 + -0.10934 0.00000 -0.22616 +multipole 98 95 100 -0.04014 + 0.12242 0.00000 0.33257 + 0.47182 + 0.00000 -0.95073 + 1.00232 0.00000 0.47891 +multipole 99 98 95 0.08943 + 0.00257 0.00000 -0.22473 + 0.04808 + 0.00000 0.07642 + -0.00228 0.00000 -0.12450 +multipole 100 98 103 0.27213 + -0.01020 0.00000 -0.04090 + -0.56550 + 0.00000 -0.84235 + 0.01760 0.00000 1.40785 +multipole 101 105 97 -0.21794 + -0.35298 0.00000 0.10109 + -0.40485 + 0.00000 0.29036 + 0.37638 0.00000 0.11449 +multipole 102 101 105 0.00801 + -0.00224 0.00000 -0.18002 + 0.06080 + 0.00000 0.00560 + -0.00836 0.00000 -0.06640 +multipole 103 107 100 -0.11761 + -0.14109 0.00000 -0.03991 + -0.10545 + 0.00000 0.00849 + 0.00884 0.00000 0.09696 +multipole 104 103 107 0.00440 + 0.00483 0.00000 -0.18511 + 0.04514 + 0.00000 0.03804 + 0.00203 0.00000 -0.08318 +multipole 105 101 107 0.10201 + 0.39384 0.00000 0.16841 + 0.80520 + 0.00000 -0.74064 + 0.63994 0.00000 -0.06456 +multipole 106 105 101 0.00775 + 0.00480 0.00000 -0.17770 + 0.05191 + 0.00000 0.02589 + 0.00432 0.00000 -0.07780 +multipole 107 105 103 -0.05764 + -0.04918 0.00000 0.00068 + 0.03545 + 0.00000 -0.17480 + -0.16395 0.00000 0.13935 +multipole 108 107 105 0.00377 + -0.00056 0.00000 -0.18221 + 0.03345 + 0.00000 0.00061 + -0.01344 0.00000 -0.03406 +multipole 109 8 111 -0.04139 + 0.26299 0.00000 0.34265 + -0.03104 + 0.00000 -0.66907 + -0.12227 0.00000 0.70011 +multipole 110 109 111 0.12549 + 0.00988 0.00000 -0.08472 + -0.00787 + 0.00000 -0.01467 + 0.00364 0.00000 0.02254 +multipole 111 109 112 0.11571 + 0.11091 0.00000 0.20553 + 0.09544 + 0.00000 -0.36654 + -0.23493 0.00000 0.27110 +multipole 112 111 116 -0.06925 + 0.09513 0.00000 0.18944 + 0.51323 + 0.00000 -0.62541 + 0.37771 0.00000 0.11218 +multipole 113 112 116 0.21415 + 0.05363 0.00000 -0.13189 + 0.01617 + 0.00000 0.05352 + -0.01202 0.00000 -0.06969 +multipole 114 111 118 0.01888 + 0.16232 0.00000 -0.27102 + 0.61022 + 0.00000 -0.20124 + -0.21377 0.00000 -0.40898 +multipole 115 114 118 0.06585 + -0.00990 0.00000 -0.23803 + 0.03073 + 0.00000 0.02508 + -0.00187 0.00000 -0.05581 +multipole 116 112 118 0.36202 + 0.26903 0.00000 0.11759 + 0.06815 + 0.00000 -0.21124 + -0.30196 0.00000 0.14309 +multipole 117 116 118 0.08951 + -0.00197 0.00000 -0.23328 + 0.03690 + 0.00000 0.02486 + -0.00452 0.00000 -0.06176 +multipole 118 114 116 -0.07427 + -0.05556 0.00000 0.07966 + 0.34564 + 0.00000 -0.66163 + 0.31368 0.00000 0.31599 +multipole 119 118 116 0.13793 + -0.00888 0.00000 -0.25043 + 0.03808 + 0.00000 0.02080 + -0.00306 0.00000 -0.05888 +multipole 120 8 122 -0.07944 + 0.17672 0.00000 0.30763 + -0.03832 + 0.00000 -0.44609 + -0.06557 0.00000 0.48441 +multipole 121 120 122 0.08230 + 0.02308 0.00000 -0.08228 + -0.02794 + 0.00000 -0.01021 + -0.00367 0.00000 0.03815 +multipole 122 120 123 0.02915 + 0.31598 0.00000 0.18435 + 0.34260 + 0.00000 -0.59879 + -0.18441 0.00000 0.25619 +multipole 123 122 127 -0.20791 + 0.39981 0.00000 0.32325 + 0.06377 + 0.00000 -0.53895 + 0.03531 0.00000 0.47518 +multipole 124 123 127 0.22642 + 0.02304 0.00000 -0.11797 + -0.16063 + 0.00000 -0.09414 + -0.05024 0.00000 0.25477 +multipole 125 122 129 0.02645 + 0.22620 0.00000 -0.16529 + 0.33999 + 0.00000 -0.44311 + -0.21659 0.00000 0.10312 +multipole 126 125 129 0.05039 + 0.02238 0.00000 -0.15563 + 0.06418 + 0.00000 -0.03197 + -0.06839 0.00000 -0.03221 +multipole 127 123 129 0.27710 + 0.29162 0.00000 0.20834 + -0.08914 + 0.00000 -0.52843 + -0.39844 0.00000 0.61757 +multipole 128 127 129 0.07110 + -0.02202 0.00000 -0.17142 + 0.20449 + 0.00000 -0.02865 + 0.00605 0.00000 -0.17584 +multipole 129 125 127 -0.48774 + 0.22946 0.00000 0.26151 + 0.03809 + 0.00000 -0.11680 + -0.10207 0.00000 0.07871 +multipole 130 8 132 -0.07191 + 0.28159 0.00000 0.28143 + 0.31037 + 0.00000 -0.69057 + 0.12423 0.00000 0.38020 +multipole 131 130 132 0.09317 + 0.00776 0.00000 -0.05959 + -0.00489 + 0.00000 -0.01510 + -0.03160 0.00000 0.01999 +multipole 132 130 133 0.21765 + 0.29985 0.00000 0.02736 + 0.07615 + 0.00000 -0.68598 + 0.04724 0.00000 0.60983 +multipole 133 132 136 -0.58085 + 0.22726 0.00000 0.17315 + -0.01899 + 0.00000 0.04259 + -0.10366 0.00000 -0.02360 +multipole 134 132 138 -0.05319 + 0.24583 0.00000 -0.18287 + 0.72454 + 0.00000 -0.35866 + -0.27504 0.00000 -0.36588 +multipole 135 134 138 0.03309 + -0.01543 0.00000 -0.18397 + 0.06413 + 0.00000 0.01079 + 0.00873 0.00000 -0.07492 +multipole 136 133 138 0.31901 + 0.20503 0.00000 0.21136 + 0.19503 + 0.00000 -0.33727 + -0.42894 0.00000 0.14224 +multipole 137 136 138 0.03395 + -0.03428 0.00000 -0.19515 + 0.05553 + 0.00000 0.03619 + -0.01089 0.00000 -0.09172 +multipole 138 134 136 -0.11867 + -0.00875 0.00000 0.10083 + 0.20131 + 0.00000 -0.72000 + 0.25215 0.00000 0.51869 +multipole 139 138 136 0.10470 + 0.00835 0.00000 -0.20453 + 0.03062 + 0.00000 0.01424 + 0.02385 0.00000 -0.04486 +multipole 140 8 142 -0.33040 + -0.11155 0.00000 0.33205 + -0.61968 + 0.00000 -0.26472 + -0.14505 0.00000 0.88440 +multipole 141 140 142 0.04893 + 0.05143 0.00000 -0.06648 + 0.28508 + 0.00000 0.01019 + 0.01023 0.00000 -0.29527 +multipole 142 -143 -143 1.01644 + 0.00000 0.00000 0.08388 + 0.38943 + 0.00000 -0.40574 + -0.48759 0.00000 0.01631 +multipole 143 142 140 -0.85689 + -0.12334 0.00000 -0.17900 + -0.30556 + 0.00000 0.15089 + -0.25593 0.00000 0.15467 +multipole 144 8 146 -0.09907 + 0.28314 0.00000 0.21299 + -0.02365 + 0.00000 -0.44590 + -0.11454 0.00000 0.46955 +multipole 145 144 146 0.09104 + -0.00783 0.00000 -0.03880 + 0.00300 + 0.00000 -0.02251 + 0.00366 0.00000 0.01951 +multipole 146 147 148 0.80267 + 0.20023 0.00000 0.07448 + 0.19047 + 0.00000 -0.27645 + -0.23208 0.00000 0.08598 +multipole 147 146 148 -0.61184 + -0.02970 0.00000 -0.14127 + -0.46989 + 0.00000 0.30054 + -0.03964 0.00000 0.16935 +multipole 148 146 149 -0.44451 + 0.25436 0.00000 -0.00470 + 0.30396 + 0.00000 -0.42103 + -0.22422 0.00000 0.11707 +multipole 149 148 146 0.24079 + -0.02916 0.00000 -0.07474 + -0.05892 + 0.00000 -0.07642 + -0.01164 0.00000 0.13534 +multipole 150 8 152 -0.15072 + 0.21350 0.00000 0.26252 + 0.05371 + 0.00000 -0.51087 + -0.14685 0.00000 0.45716 +multipole 151 150 152 0.09679 + 0.03329 0.00000 -0.09671 + 0.39142 + 0.00000 -0.06880 + 0.00874 0.00000 -0.32262 +multipole 152 154 153 0.76960 + 0.30627 0.00000 -0.09362 + 0.21156 + 0.00000 -0.39797 + 0.03345 0.00000 0.18641 +multipole 153 152 154 -0.72950 + -0.03688 0.00000 -0.16002 + -0.27527 + 0.00000 0.26973 + 0.01067 0.00000 0.00554 +multipole 154 152 153 -0.38020 + 0.09353 0.00000 0.22182 + -0.15418 + 0.00000 -0.46630 + 0.22562 0.00000 0.62048 +multipole 155 154 152 0.18368 + -0.03978 0.00000 -0.31735 + 0.10703 + 0.00000 0.19471 + -0.10853 0.00000 -0.30174 +multipole 156 8 158 0.00410 + 0.19527 0.00000 0.18895 + 0.21464 + 0.00000 -0.87217 + -0.58720 0.00000 0.65753 +multipole 157 156 158 0.04082 + 0.05593 0.00000 -0.13609 + 0.19339 + 0.00000 0.00486 + 0.13648 0.00000 -0.19825 +multipole 158 156 160 -0.36014 + -0.21199 0.00000 0.25528 + -0.92519 + 0.00000 0.11101 + -0.02016 0.00000 0.81418 +multipole 159 158 160 -0.00356 + 0.01435 0.00000 -0.03733 + 0.30641 + 0.00000 -0.10229 + -0.17820 0.00000 -0.20412 +multipole 160 -161 -161 1.14596 + 0.00000 0.00000 -0.08110 + 0.47468 + 0.00000 -0.53790 + -0.20865 0.00000 0.06322 +multipole 161 160 161 -0.89716 + 0.23089 0.00000 -0.27964 + -0.48791 + 0.00000 0.28534 + 0.25648 0.00000 0.20257 +multipole 162 8 164 -0.07714 + 0.26038 0.00000 0.20993 + 0.22883 + 0.00000 -0.64833 + -0.23553 0.00000 0.41950 +multipole 163 162 8 0.09378 + -0.01574 0.00000 -0.05078 + -0.02530 + 0.00000 0.00147 + 0.02003 0.00000 0.02383 +multipole 164 162 166 -0.20674 + 0.26277 0.00000 0.16246 + -0.04934 + 0.00000 -0.40226 + -0.12563 0.00000 0.45160 +multipole 165 164 166 0.09104 + -0.00783 0.00000 -0.03880 + 0.00300 + 0.00000 -0.02251 + 0.00366 0.00000 0.01951 +multipole 166 167 168 0.80267 + 0.20023 0.00000 0.07448 + 0.19047 + 0.00000 -0.27645 + -0.23208 0.00000 0.08598 +multipole 167 166 168 -0.61184 + -0.02970 0.00000 -0.14127 + -0.46989 + 0.00000 0.30054 + -0.03964 0.00000 0.16935 +multipole 168 166 169 -0.44451 + 0.25436 0.00000 -0.00470 + 0.30396 + 0.00000 -0.42103 + -0.22422 0.00000 0.11707 +multipole 169 168 166 0.24079 + -0.02916 0.00000 -0.07474 + -0.05892 + 0.00000 -0.07642 + -0.01164 0.00000 0.13534 +multipole 170 8 172 -0.12108 + 0.20829 0.00000 0.25236 + 0.20153 + 0.00000 -0.62121 + -0.31273 0.00000 0.41968 +multipole 171 170 8 0.05947 + -0.00523 0.00000 -0.09278 + -0.00153 + 0.00000 0.01003 + 0.11637 0.00000 -0.00850 +multipole 172 170 174 -0.14858 + 0.36021 0.00000 0.30124 + 0.02345 + 0.00000 -0.56744 + 0.02425 0.00000 0.54399 +multipole 173 172 174 0.09679 + 0.03329 0.00000 -0.09671 + 0.39142 + 0.00000 -0.06880 + 0.00874 0.00000 -0.32262 +multipole 174 176 175 0.76960 + 0.30627 0.00000 -0.09362 + 0.21156 + 0.00000 -0.39797 + 0.03345 0.00000 0.18641 +multipole 175 174 176 -0.72950 + -0.03688 0.00000 -0.16002 + -0.27527 + 0.00000 0.26973 + 0.01067 0.00000 0.00554 +multipole 176 174 175 -0.38020 + 0.09353 0.00000 0.22182 + -0.15418 + 0.00000 -0.46630 + 0.22562 0.00000 0.62048 +multipole 177 176 174 0.18368 + -0.03978 0.00000 -0.31735 + 0.10703 + 0.00000 0.19471 + -0.10853 0.00000 -0.30174 +multipole 178 8 180 -0.02949 + 0.25798 0.00000 0.20067 + 0.18156 + 0.00000 -0.53649 + -0.23437 0.00000 0.35493 +multipole 179 178 180 0.06373 + 0.02199 0.00000 -0.08918 + -0.00122 + 0.00000 0.01893 + 0.07446 0.00000 -0.01771 +multipole 180 182 178 -0.07285 + 0.10294 0.00000 -0.14760 + 0.07610 + 0.00000 0.00950 + -0.40971 0.00000 -0.08560 +multipole 181 180 182 0.00251 + 0.00920 0.00000 -0.06833 + 0.06767 + 0.00000 -0.04966 + 0.05119 0.00000 -0.01801 +multipole 182 180 183 0.06969 + 0.45487 0.00000 0.40067 + 1.23884 + 0.00000 -2.84799 + -0.97916 0.00000 1.60915 +multipole 183 182 180 -0.15553 + 0.07637 0.00000 0.05437 + -0.24774 + 0.00000 0.25322 + 0.17760 0.00000 -0.00548 +multipole 184 183 182 0.04194 + 0.01008 0.00000 -0.10323 + 0.07224 + 0.00000 -0.02305 + -0.03128 0.00000 -0.04919 +multipole 185 8 187 0.01417 + 0.14321 0.00000 0.20704 + 0.30355 + 0.00000 -0.78336 + -0.49884 0.00000 0.47981 +multipole 186 185 187 0.06168 + 0.01034 0.00000 -0.06926 + -0.00481 + 0.00000 -0.01041 + 0.00120 0.00000 0.01522 +multipole 187 189 185 -0.14658 + 0.07407 0.00000 0.27751 + -0.00731 + 0.00000 -0.45713 + -0.03370 0.00000 0.46444 +multipole 188 187 188 0.07914 + -0.02214 0.00000 -0.05705 + -0.01403 + 0.00000 -0.00903 + -0.01009 0.00000 0.02306 +multipole 189 191 187 -0.12517 + 0.10322 0.00000 0.30901 + -0.01151 + 0.00000 -0.54904 + -0.16768 0.00000 0.56055 +multipole 190 189 190 0.07947 + -0.01804 0.00000 -0.05617 + -0.00416 + 0.00000 -0.02346 + -0.00980 0.00000 0.02762 +multipole 191 193 189 -0.00637 + 0.14897 0.00000 0.45848 + -0.16613 + 0.00000 -0.75850 + -0.13391 0.00000 0.92463 +multipole 192 191 192 0.10424 + -0.02167 0.00000 -0.06885 + 0.00577 + 0.00000 -0.00847 + -0.00310 0.00000 0.00270 +multipole 193 191 194 0.10679 + 0.00000 0.00000 0.12676 + -0.16979 + 0.00000 -0.13104 + 0.03239 0.00000 0.30083 +multipole 194 193 191 0.19274 + 0.03789 0.00000 -0.14079 + 0.01248 + 0.00000 -0.00338 + 0.01511 0.00000 -0.00910 +multipole 195 8 197 0.01417 + 0.14321 0.00000 0.20704 + 0.30355 + 0.00000 -0.78336 + -0.49884 0.00000 0.47981 +multipole 196 195 197 0.06168 + 0.01034 0.00000 -0.06926 + -0.00481 + 0.00000 -0.01041 + 0.00120 0.00000 0.01522 +multipole 197 195 199 -0.23796 + 0.19414 0.00000 0.14744 + 0.14341 + 0.00000 -0.47693 + -0.11332 0.00000 0.33352 +multipole 198 197 198 0.07914 + -0.02214 0.00000 -0.05705 + -0.01403 + 0.00000 -0.00903 + -0.01009 0.00000 0.02306 +multipole 199 197 201 -0.11624 + 0.21269 0.00000 0.09089 + 0.20210 + 0.00000 -0.39596 + -0.20937 0.00000 0.19386 +multipole 200 199 200 0.05672 + -0.01831 0.00000 -0.07935 + 0.15924 + 0.00000 -0.06424 + 0.10917 0.00000 -0.09500 +multipole 201 203 199 0.11242 + 0.21133 0.00000 0.33886 + 0.02196 + 0.00000 -0.48911 + -0.25303 0.00000 0.46715 +multipole 202 201 202 0.02390 + 0.01872 0.00000 -0.12033 + 0.09851 + 0.00000 0.11826 + 0.07069 0.00000 -0.21677 +multipole 203 201 -204 -204 -0.30941 + 0.33655 0.00000 0.15544 + -0.89694 + 0.00000 0.57332 + -0.40985 0.00000 0.32362 +multipole 204 203 201 0.08213 + -0.02480 0.00000 -0.10241 + -0.09247 + 0.00000 -0.02510 + 0.06165 0.00000 0.11757 +multipole 205 8 207 -0.05810 + 0.20447 0.00000 0.22675 + 0.15418 + 0.00000 -0.61290 + -0.20381 0.00000 0.45872 +multipole 206 205 207 0.07332 + 0.02865 0.00000 -0.07066 + -0.01727 + 0.00000 0.05136 + -0.02048 0.00000 -0.03409 +multipole 207 205 209 -0.12460 + 0.34262 0.00000 0.10892 + 0.29827 + 0.00000 -0.61801 + -0.41083 0.00000 0.31974 +multipole 208 207 208 0.10013 + -0.02406 0.00000 -0.04574 + 0.04356 + 0.00000 0.04278 + 0.03604 0.00000 -0.08634 +multipole 209 207 211 -0.00504 + 0.31217 0.00000 0.12183 + 0.63851 + 0.00000 -0.60326 + -0.42746 0.00000 -0.03525 +multipole 210 209 210 0.06386 + 0.00521 0.00000 -0.12606 + 0.06805 + 0.00000 0.12031 + 0.04448 0.00000 -0.18836 +multipole 211 209 213 -0.26789 + -0.17032 0.00000 0.38423 + 0.13132 + 0.00000 -0.85952 + 0.18957 0.00000 0.72820 +multipole 212 211 213 0.14895 + -0.02053 0.00000 -0.19388 + 0.07464 + 0.00000 0.03688 + 0.08593 0.00000 -0.11152 +multipole 213 -214 -214 0.90680 + 0.00412 0.00000 0.01818 + -0.11120 + 0.00000 0.07010 + -0.02109 0.00000 0.04110 +multipole 214 213 214 -0.30169 + -0.00168 0.00000 -0.24721 + 0.43113 + 0.00000 -0.69170 + -0.07379 0.00000 0.26057 +multipole 215 214 213 0.14969 + 0.01642 0.00000 -0.22002 + 0.17410 + 0.00000 -0.03308 + -0.02767 0.00000 -0.14102 +multipole 216 8 218 0.01417 + 0.14321 0.00000 0.20704 + 0.30355 + 0.00000 -0.78336 + -0.49884 0.00000 0.47981 +multipole 217 216 218 0.06168 + 0.01034 0.00000 -0.06926 + -0.00481 + 0.00000 -0.01041 + 0.00120 0.00000 0.01522 +multipole 218 220 216 -0.12127 + 0.10322 0.00000 0.30901 + -0.01151 + 0.00000 -0.54904 + -0.16768 0.00000 0.56055 +multipole 219 218 219 0.08337 + -0.01804 0.00000 -0.05617 + -0.00416 + 0.00000 -0.02346 + -0.00980 0.00000 0.02762 +multipole 220 222 218 -0.00637 + 0.14897 0.00000 0.45848 + -0.16613 + 0.00000 -0.75850 + -0.13391 0.00000 0.92463 +multipole 221 220 221 0.10424 + -0.02167 0.00000 -0.06885 + 0.00577 + 0.00000 -0.00847 + -0.00310 0.00000 0.00270 +multipole 222 220 223 0.10679 + 0.00000 0.00000 0.12676 + -0.16979 + 0.00000 -0.13104 + 0.03239 0.00000 0.30083 +multipole 223 222 220 0.19274 + 0.03789 0.00000 -0.14079 + 0.01248 + 0.00000 -0.00338 + 0.01511 0.00000 -0.00910 +multipole 224 226 227 -0.19495 + -0.05933 0.00000 0.30647 + -0.12000 + 0.00000 -0.18289 + 0.06006 0.00000 0.30289 +multipole 225 224 226 0.07797 + -0.00148 0.00000 -0.10232 + 0.00077 + 0.00000 -0.01358 + 0.00508 0.00000 0.01281 +multipole 226 227 224 0.70656 + -0.28625 0.00000 0.40485 + 0.09631 + 0.00000 -0.19283 + 0.05482 0.00000 0.09652 +multipole 227 226 224 -0.74615 + 0.10832 0.00000 -0.15915 + -0.51576 + 0.00000 0.23754 + 0.12638 0.00000 0.27822 +multipole 228 -229 -229 -0.25887 + 0.00000 0.00000 0.11888 + 0.60320 + 0.00000 -0.68404 + -0.03938 0.00000 0.08084 +multipole 229 228 229 0.12975 + 0.00964 0.00000 -0.17930 + 0.02173 + 0.00000 -0.03357 + 0.00745 0.00000 0.01184 +multipole 230 232 231 -0.27516 + 0.12868 0.00000 0.29428 + 0.13167 + 0.00000 -0.77946 + -0.26698 0.00000 0.64779 +multipole 231 230 232 0.12524 + 0.04469 0.00000 -0.11589 + 0.03867 + 0.00000 -0.05683 + 0.02734 0.00000 0.01816 +multipole 232 230 231 -0.00902 + 0.04962 0.00000 0.26123 + -0.42853 + 0.00000 -0.34055 + 0.01113 0.00000 0.76908 +multipole 233 232 230 0.05319 + -0.00200 0.00000 -0.11501 + 0.00409 + 0.00000 -0.00544 + -0.00819 0.00000 0.00135 +multipole 234 2 235 0.11164 + 0.00000 0.00000 0.13883 + -0.17000 + 0.00000 -0.34475 + -0.01419 0.00000 0.51475 +multipole 234 8 235 0.11164 + 0.00000 0.00000 0.13883 + -0.17000 + 0.00000 -0.34475 + -0.01419 0.00000 0.51475 +multipole 234 33 235 0.11164 + 0.00000 0.00000 0.13883 + -0.17000 + 0.00000 -0.34475 + -0.01419 0.00000 0.51475 +multipole 234 44 235 0.11164 + 0.00000 0.00000 0.13883 + -0.17000 + 0.00000 -0.34475 + -0.01419 0.00000 0.51475 +multipole 235 234 2 0.21240 + 0.00000 0.00000 -0.12490 + 0.03622 + 0.00000 -0.01437 + 0.00000 0.00000 -0.02185 +multipole 235 234 8 0.21240 + 0.00000 0.00000 -0.12490 + 0.03622 + 0.00000 -0.01437 + 0.00000 0.00000 -0.02185 +multipole 235 234 33 0.21240 + 0.00000 0.00000 -0.12490 + 0.03622 + 0.00000 -0.01437 + 0.00000 0.00000 -0.02185 +multipole 235 234 44 0.21240 + 0.00000 0.00000 -0.12490 + 0.03622 + 0.00000 -0.01437 + 0.00000 0.00000 -0.02185 +multipole 236 2 -237 -237 -0.29203 + 0.39162 0.00000 0.29820 + -0.82241 + 0.00000 0.30190 + -0.26688 0.00000 0.52051 +multipole 236 8 -237 -237 -0.29203 + 0.39162 0.00000 0.29820 + -0.82241 + 0.00000 0.30190 + -0.26688 0.00000 0.52051 +multipole 236 33 -237 -237 -0.29203 + 0.39162 0.00000 0.29820 + -0.82241 + 0.00000 0.30190 + -0.26688 0.00000 0.52051 +multipole 236 44 -237 -237 -0.29203 + 0.39162 0.00000 0.29820 + -0.82241 + 0.00000 0.30190 + -0.26688 0.00000 0.52051 +multipole 237 236 237 0.09729 + -0.02365 0.00000 -0.07786 + -0.02419 + 0.00000 -0.00850 + -0.00527 0.00000 0.03269 +multipole 238 -239 -239 1.02669 + 0.00000 0.00000 -0.06887 + 0.36390 + 0.00000 -0.45669 + 0.00000 0.00000 0.09279 +multipole 239 238 239 -0.90443 + 0.19119 0.00000 -0.19259 + -0.45071 + 0.00000 0.24406 + 0.16925 0.00000 0.20665 +multipole 240 241 2 0.90327 + -0.07798 0.00000 0.05629 + 0.20073 + 0.00000 -0.34953 + 0.34032 0.00000 0.14880 +multipole 240 241 8 0.90327 + -0.07798 0.00000 0.05629 + 0.20073 + 0.00000 -0.34953 + 0.34032 0.00000 0.14880 +multipole 240 241 33 0.90327 + -0.07798 0.00000 0.05629 + 0.20073 + 0.00000 -0.34953 + 0.34032 0.00000 0.14880 +multipole 240 241 44 0.90327 + -0.07798 0.00000 0.05629 + 0.20073 + 0.00000 -0.34953 + 0.34032 0.00000 0.14880 +multipole 241 240 2 -0.65062 + -0.01381 0.00000 -0.15899 + -0.50252 + 0.00000 0.31170 + -0.01833 0.00000 0.19082 +multipole 241 240 8 -0.65062 + -0.01381 0.00000 -0.15899 + -0.50252 + 0.00000 0.31170 + -0.01833 0.00000 0.19082 +multipole 241 240 33 -0.65062 + -0.01381 0.00000 -0.15899 + -0.50252 + 0.00000 0.31170 + -0.01833 0.00000 0.19082 +multipole 241 240 44 -0.65062 + -0.01381 0.00000 -0.15899 + -0.50252 + 0.00000 0.31170 + -0.01833 0.00000 0.19082 +multipole 242 240 243 -0.47859 + 0.29403 0.00000 -0.07342 + 0.32137 + 0.00000 -0.37927 + -0.15981 0.00000 0.05790 +multipole 243 242 240 0.24567 + -0.01982 0.00000 -0.07068 + -0.05831 + 0.00000 -0.07908 + -0.01391 0.00000 0.13739 +multipole 244 246 250 0.07219 + 0.28913 0.00000 0.29472 + 0.20132 + 0.00000 -0.54286 + 0.05155 0.00000 0.34154 +multipole 245 244 245 0.23262 + -0.02789 0.00000 -0.04288 + 0.00231 + 0.00000 0.03311 + -0.02313 0.00000 -0.03542 +multipole 246 244 247 -0.16428 + 0.16276 0.20457 0.47894 + -0.28250 + -0.26022 -0.34943 + 0.25272 -0.20303 0.63193 +multipole 247 248 246 0.93900 + 0.00000 0.00000 0.32359 + 0.14171 + 0.00000 -0.31370 + 0.03825 0.00000 0.17199 +multipole 248 247 246 -0.74794 + 0.02444 0.00000 -0.13267 + -0.59982 + 0.00000 0.24285 + -0.01926 0.00000 0.35697 +multipole 249 246 58 0.12611 + 0.01772 0.00000 0.00501 + 0.02059 + 0.00000 -0.01260 + 0.01759 0.00000 -0.00799 +multipole 250 60 244 -0.04567 + 0.56406 0.00000 0.09733 + 0.69818 + 0.00000 -0.78665 + -0.18468 0.00000 0.08847 +multipole 251 250 244 0.10559 + -0.01503 0.00000 -0.07122 + 0.00434 + 0.00000 -0.00248 + -0.01523 0.00000 -0.00186 +multipole 252 256 253 -0.12218 + 0.03811 0.00000 -0.08600 + 0.62317 + 0.00000 -1.19258 + 0.19520 0.00000 0.56941 +multipole 253 257 252 0.10618 + 0.14960 0.00000 -0.12837 + 0.37561 + 0.00000 -1.08479 + -0.08751 0.00000 0.70918 +multipole 254 255 260 0.03294 + -0.03102 0.00000 0.00884 + 0.54936 + 0.00000 -1.16758 + -0.21224 0.00000 0.61822 +multipole 255 256 254 -0.29610 + 0.61528 0.00000 0.42732 + 0.23662 + 0.00000 -0.71274 + -0.59516 0.00000 0.47612 +multipole 256 255 252 0.12091 + 0.29466 0.00000 0.04441 + 0.57178 + 0.00000 -0.97127 + 0.05984 0.00000 0.39949 +multipole 257 258 253 -0.28556 + 0.65052 0.00000 0.32181 + 0.12041 + 0.00000 -0.70422 + -0.73445 0.00000 0.58381 +multipole 258 259 257 0.09440 + 0.17177 0.00000 0.08338 + 0.42911 + 0.00000 -0.89289 + -0.05831 0.00000 0.46378 +multipole 259 260 258 -0.30504 + 0.51018 0.00000 0.44518 + -0.10277 + 0.00000 -0.67553 + -0.76206 0.00000 0.77830 +multipole 260 259 262 0.11701 + -0.02847 0.00000 -0.01015 + 0.48527 + 0.00000 -0.91170 + 0.00027 0.00000 0.42643 +multipole 261 258 259 0.10987 + 0.00260 0.00000 0.16138 + -0.00401 + 0.00000 -0.14100 + -0.00062 0.00000 0.14501 +multipole 262 260 263 -0.28195 + 0.00000 0.00000 0.28691 + 0.77307 + 0.00000 -1.54614 + 0.00000 0.00000 0.77307 +multipole 263 262 260 0.23408 + 0.03256 0.00000 0.10841 + 0.00094 + 0.00000 -0.15824 + -0.00749 0.00000 0.15730 +multipole 264 262 260 0.23408 + 0.03256 0.00000 0.10841 + 0.00094 + 0.00000 -0.15824 + -0.00749 0.00000 0.15730 +multipole 265 256 252 0.12346 + 0.00882 0.00000 0.15889 + -0.01175 + 0.00000 -0.14419 + 0.01352 0.00000 0.15594 +multipole 266 267 271 -0.12896 + -0.11355 0.00000 0.02174 + 0.67152 + 0.00000 -1.21177 + -0.10266 0.00000 0.54025 +multipole 267 272 268 0.25555 + -0.14070 0.00000 -0.03554 + 0.26985 + -0.00001 -0.69302 + -0.03330 0.00000 0.42317 +multipole 268 267 269 -0.29612 + 0.53921 0.00000 0.28660 + -0.04511 + 0.00000 -0.75164 + -0.89326 0.00000 0.79675 +multipole 269 268 273 0.10206 + 0.01957 0.00000 0.12801 + 0.47115 + 0.00000 -0.89630 + -0.01741 0.00000 0.42515 +multipole 270 269 271 -0.08445 + 0.15647 0.00000 0.19000 + 0.70078 + 0.00000 -1.36350 + 0.01622 0.00000 0.66272 +multipole 271 266 270 0.09191 + 0.09270 0.00000 0.29758 + 0.55799 + 0.00000 -1.06685 + -0.02963 0.00000 0.50886 +multipole 272 267 266 -0.42963 + -0.05223 0.00000 0.54613 + -0.69717 + 0.00000 -0.34383 + 0.07116 0.00000 1.04100 +multipole 273 269 274 -0.28291 + 0.00000 0.00000 0.25147 + 0.76777 + 0.00000 -1.53554 + 0.00000 0.00000 0.76777 +multipole 274 273 269 0.22172 + 0.03599 0.00000 0.11263 + -0.00271 + 0.00000 -0.15749 + 0.00206 0.00000 0.16020 +multipole 275 273 269 0.22172 + 0.03599 0.00000 0.11263 + -0.00271 + 0.00000 -0.15749 + 0.00206 0.00000 0.16020 +multipole 276 270 269 0.09969 + 0.02298 0.00000 0.17496 + 0.00319 + 0.00000 -0.16978 + -0.00323 0.00000 0.16659 +multipole 277 271 266 0.11152 + 0.02437 0.00000 0.17240 + -0.00098 + 0.00000 -0.14128 + 0.00098 0.00000 0.14226 +multipole 278 282 279 -0.12123 + 0.03277 0.00000 -0.10629 + 0.63111 + 0.00000 -1.19809 + 0.19068 0.00000 0.56698 +multipole 279 283 278 0.11988 + 0.19633 0.00000 -0.06061 + 0.38997 + 0.00000 -1.12316 + -0.07428 0.00000 0.73319 +multipole 280 281 286 0.05939 + -0.10783 0.00000 0.02921 + 0.63397 + 0.00000 -1.23333 + -0.17725 0.00000 0.59936 +multipole 281 282 280 -0.25427 + 0.59171 0.00000 0.39016 + 0.15889 + 0.00000 -0.73445 + -0.53511 0.00000 0.57556 +multipole 282 281 278 0.05900 + 0.29666 0.00000 0.03459 + 0.59303 + 0.00000 -1.00768 + 0.05948 0.00000 0.41465 +multipole 283 284 279 -0.32183 + 0.57617 0.00000 0.41136 + 0.04364 + 0.00000 -0.79668 + -0.81270 0.00000 0.75304 +multipole 284 283 285 0.16650 + 0.04683 0.00000 0.10382 + 0.42221 + 0.00000 -0.84366 + 0.03151 0.00000 0.42145 +multipole 285 286 284 -0.20681 + 0.13302 0.00000 0.01206 + 0.66907 + 0.00000 -1.32924 + -0.20370 0.00000 0.66017 +multipole 286 291 285 0.22596 + 0.01495 0.00000 -0.07785 + 0.18997 + 0.00000 -0.72984 + 0.02836 0.00000 0.53987 +multipole 287 285 286 0.25827 + -0.01369 0.00000 0.11644 + 0.02819 + 0.00000 -0.12664 + -0.01016 0.00000 0.09845 +multipole 288 284 289 -0.30237 + 0.00000 0.00000 0.28852 + 0.63383 + 0.00000 -1.56322 + 0.00000 0.00000 0.92939 +multipole 289 288 284 0.22815 + 0.03988 0.00000 0.11016 + -0.00150 + 0.00000 -0.16140 + 0.00075 0.00000 0.16290 +multipole 290 288 284 0.22815 + 0.03988 0.00000 0.11016 + -0.00150 + 0.00000 -0.16140 + 0.00075 0.00000 0.16290 +multipole 291 286 285 -0.37776 + -0.06443 0.00000 0.49534 + -0.70985 + 0.00000 -0.26340 + 0.02536 0.00000 0.97325 +multipole 292 282 278 0.12107 + 0.01058 0.00000 0.15550 + -0.00871 + 0.00000 -0.14972 + 0.01430 0.00000 0.15843 +multipole 293 294 298 -0.15031 + -0.09046 0.00000 0.02457 + 0.65601 + 0.00000 -1.24652 + -0.08497 0.00000 0.59051 +multipole 294 299 293 0.25814 + 0.18207 0.00000 -0.10742 + 0.22241 + 0.00000 -0.69573 + 0.00586 0.00000 0.47332 +multipole 295 294 296 -0.18494 + 0.09040 0.00000 0.07592 + 0.52488 + 0.00000 -1.31753 + -0.14409 0.00000 0.79265 +multipole 296 301 295 0.20468 + -0.03331 0.00000 -0.08396 + 0.22917 + 0.00000 -0.73017 + -0.00765 0.00000 0.50100 +multipole 297 296 298 -0.10776 + -0.07708 0.00000 0.02024 + 0.69315 + 0.00000 -1.22595 + -0.07168 0.00000 0.53280 +multipole 298 293 297 0.02014 + 0.13147 0.00000 0.23798 + 0.52729 + 0.00000 -1.10293 + -0.13608 0.00000 0.57564 +multipole 299 294 293 -0.42656 + -0.00821 0.00000 0.52363 + -0.76229 + 0.00000 -0.32575 + 0.04661 0.00000 1.08804 +multipole 300 295 294 0.27344 + 0.00655 0.00000 0.12419 + 0.02392 + 0.00000 -0.12278 + -0.00027 0.00000 0.09886 +multipole 301 296 295 -0.40427 + 0.01291 0.00000 0.51762 + -0.81344 + 0.00000 -0.24421 + -0.00636 0.00000 1.05765 +multipole 302 297 303 -0.09928 + 0.00000 0.00000 0.16142 + -0.10106 + 0.00000 -0.10106 + 0.00000 0.00000 0.20212 +multipole 303 302 297 0.12786 + 0.04661 0.00000 0.13652 + -0.04143 + 0.00000 -0.10340 + -0.01205 0.00000 0.14483 +multipole 304 298 293 0.11524 + 0.01748 0.00000 0.18372 + 0.01572 + 0.00000 -0.13911 + -0.00351 0.00000 0.12339 +multipole 305 306 310 -0.11970 + -0.12748 0.00000 0.03261 + 0.65308 + 0.00000 -1.23647 + -0.08490 0.00000 0.58339 +multipole 306 311 305 0.26026 + 0.18047 0.00000 -0.06071 + 0.22206 + 0.00000 -0.68694 + 0.00805 0.00000 0.46488 +multipole 307 306 308 -0.18804 + 0.05643 0.00000 0.09035 + 0.51668 + 0.00000 -1.31595 + -0.14138 0.00000 0.79927 +multipole 308 313 307 0.20160 + 0.08304 0.00000 -0.05600 + 0.14871 + 0.00000 -0.69528 + -0.00421 0.00000 0.54657 +multipole 309 308 310 -0.05028 + 0.13971 0.00000 0.11658 + 0.72742 + 0.00000 -1.30088 + -0.08699 0.00000 0.57346 +multipole 310 305 309 0.07568 + 0.05068 0.00000 0.30269 + 0.54514 + 0.00000 -1.07260 + -0.06180 0.00000 0.52746 +multipole 311 306 305 -0.42057 + -0.00798 0.00000 0.50266 + -0.76279 + 0.00000 -0.31846 + 0.04824 0.00000 1.08125 +multipole 312 307 306 0.27376 + 0.00919 0.00000 0.09970 + 0.02355 + 0.00000 -0.12300 + -0.00028 0.00000 0.09945 +multipole 313 308 307 -0.38720 + -0.00599 0.00000 0.48268 + -0.77753 + 0.00000 -0.22144 + 0.03766 0.00000 0.99897 +multipole 314 309 308 0.12060 + 0.01488 0.00000 0.14584 + -0.00132 + 0.00000 -0.16042 + -0.01362 0.00000 0.16174 +multipole 315 310 305 0.11599 + 0.02971 0.00000 0.15040 + -0.00005 + 0.00000 -0.14202 + 0.00241 0.00000 0.14207 +multipole 316 378 317 -0.52467 + 0.48068 0.00000 -0.09996 + 0.36295 + 0.00000 -0.87560 + -0.49890 0.00000 0.51265 +multipole 317 320 318 0.05049 + 0.00000 0.00000 0.33253 + -0.07256 + 0.00000 -0.07256 + 0.00000 0.00000 0.14512 +multipole 318 317 319 0.07556 + 0.03873 0.00000 0.14751 + -0.08294 + 0.00000 -0.01783 + -0.01217 0.00000 0.10077 +multipole 319 317 318 0.07556 + 0.03873 0.00000 0.14751 + -0.08294 + 0.00000 -0.01783 + -0.01217 0.00000 0.10077 +multipole 320 325 321 0.10423 + -0.13285 0.00000 0.29667 + -0.05793 + 0.00000 0.00086 + 0.08206 0.00000 0.05707 +multipole 321 320 322 0.13028 + 0.01734 0.00000 0.19825 + -0.05326 + 0.00000 -0.01234 + -0.00361 0.00000 0.06560 +multipole 322 323 320 -0.40197 + 0.54028 0.00000 0.40904 + 0.35989 + 0.00000 -1.06741 + -0.40034 0.00000 0.70752 +multipole 323 324 327 0.06316 + 0.28383 0.00000 -0.13756 + 0.02849 + 0.00000 0.17299 + 0.01391 0.00000 -0.20148 +multipole 324 323 322 0.18443 + 0.01626 0.00000 0.20540 + -0.04301 + 0.00000 -0.01489 + -0.01787 0.00000 0.05790 +multipole 325 327 320 0.10143 + -0.37871 0.00000 -0.13798 + 0.13330 + 0.00000 -0.04778 + 0.10936 0.00000 -0.08552 +multipole 326 325 327 0.11227 + -0.01614 0.00000 0.20173 + -0.05953 + 0.00000 -0.00856 + 0.00915 0.00000 0.06809 +multipole 327 329 328 0.06213 + -0.32405 0.00000 -0.06050 + -0.05803 + 0.00000 -0.15345 + 0.14580 0.00000 0.21148 +multipole 328 327 329 0.11711 + -0.00447 0.00000 0.19801 + -0.00750 + 0.00000 -0.04433 + -0.00421 0.00000 0.05183 +multipole 329 327 330 -0.47891 + 0.13592 0.00000 0.42081 + 0.35793 + 0.00000 -1.07684 + -0.39656 0.00000 0.71891 +multipole 330 329 327 0.32469 + 0.02934 0.00000 0.13804 + 0.00130 + 0.00000 -0.09712 + -0.01165 0.00000 0.09582 +multipole 331 378 325 -0.53467 + 0.21061 0.00000 0.49486 + 0.30847 + 0.00000 -1.03109 + -0.35505 0.00000 0.72262 +multipole 332 378 333 -0.52467 + 0.48068 0.00000 -0.09996 + 0.36295 + 0.00000 -0.87560 + -0.49890 0.00000 0.51265 +multipole 333 336 334 0.05049 + 0.00000 0.00000 0.33253 + -0.07256 + 0.00000 -0.07256 + 0.00000 0.00000 0.14512 +multipole 334 333 335 0.07556 + 0.03873 0.00000 0.14751 + -0.08294 + 0.00000 -0.01783 + -0.01217 0.00000 0.10077 +multipole 335 333 334 0.07556 + 0.03873 0.00000 0.14751 + -0.08294 + 0.00000 -0.01783 + -0.01217 0.00000 0.10077 +multipole 336 341 337 0.10423 + -0.13285 0.00000 0.29667 + -0.05793 + 0.00000 0.00086 + 0.08206 0.00000 0.05707 +multipole 337 336 338 0.13028 + 0.01734 0.00000 0.19825 + -0.05326 + 0.00000 -0.01234 + -0.00361 0.00000 0.06560 +multipole 338 339 336 -0.40197 + 0.54028 0.00000 0.40904 + 0.35989 + 0.00000 -1.06741 + -0.40034 0.00000 0.70752 +multipole 339 340 343 0.06316 + 0.28383 0.00000 -0.13756 + 0.02849 + 0.00000 0.17299 + 0.01391 0.00000 -0.20148 +multipole 340 339 338 0.18443 + 0.01626 0.00000 0.20540 + -0.04301 + 0.00000 -0.01489 + -0.01787 0.00000 0.05790 +multipole 341 343 336 0.10143 + -0.37871 0.00000 -0.13798 + 0.13330 + 0.00000 -0.04778 + 0.10936 0.00000 -0.08552 +multipole 342 341 343 0.11227 + -0.01614 0.00000 0.20173 + -0.05953 + 0.00000 -0.00856 + 0.00915 0.00000 0.06809 +multipole 343 345 344 0.06213 + -0.32405 0.00000 -0.06050 + -0.05803 + 0.00000 -0.15345 + 0.14580 0.00000 0.21148 +multipole 344 343 345 0.11711 + -0.00447 0.00000 0.19801 + -0.00750 + 0.00000 -0.04433 + -0.00421 0.00000 0.05183 +multipole 345 343 346 -0.47891 + 0.13592 0.00000 0.42081 + 0.35793 + 0.00000 -1.07684 + -0.39656 0.00000 0.71891 +multipole 346 345 343 0.32469 + 0.02934 0.00000 0.13804 + 0.00130 + 0.00000 -0.09712 + -0.01165 0.00000 0.09582 +multipole 347 378 341 -0.53467 + 0.21061 0.00000 0.49486 + 0.30847 + 0.00000 -1.03109 + -0.35505 0.00000 0.72262 +multipole 348 390 349 -0.52467 + 0.48068 0.00000 -0.09996 + 0.36295 + 0.00000 -0.87560 + -0.49890 0.00000 0.51265 +multipole 349 352 350 0.00960 + 0.00000 0.00000 0.32394 + -0.07147 + 0.00000 -0.07147 + 0.00000 0.00000 0.14294 +multipole 350 349 351 0.07556 + 0.03873 0.00000 0.14751 + -0.08294 + 0.00000 -0.01783 + -0.01217 0.00000 0.10077 +multipole 351 349 350 0.07556 + 0.03873 0.00000 0.14751 + -0.08294 + 0.00000 -0.01783 + -0.01217 0.00000 0.10077 +multipole 352 353 357 0.15826 + 0.24623 0.00000 -0.21242 + 0.08205 + 0.00000 -0.00618 + 0.03696 0.00000 -0.07587 +multipole 353 352 354 0.12800 + 0.02154 0.00000 0.20007 + -0.05590 + 0.00000 -0.00935 + -0.00576 0.00000 0.06525 +multipole 354 355 352 -0.38842 + 0.55727 0.00000 0.37834 + 0.35493 + 0.00000 -1.07262 + -0.43151 0.00000 0.71769 +multipole 355 354 359 0.06720 + 0.26362 0.00000 0.03922 + 0.05443 + 0.00000 -0.09570 + 0.15343 0.00000 0.04127 +multipole 356 355 354 0.12287 + 0.02353 0.00000 0.19270 + -0.05515 + 0.00000 -0.01305 + -0.02241 0.00000 0.06820 +multipole 357 352 359 0.07060 + 0.28362 0.00000 0.21969 + 0.09901 + 0.00000 0.02642 + 0.14299 0.00000 -0.12543 +multipole 358 357 352 0.10297 + -0.00352 0.00000 0.21211 + -0.04895 + 0.00000 -0.01013 + -0.01963 0.00000 0.05908 +multipole 359 357 355 -0.10232 + 0.30155 0.00000 0.23708 + 0.03425 + 0.00000 -0.14123 + 0.16905 0.00000 0.10698 +multipole 360 359 357 0.10225 + 0.01188 0.00000 0.17915 + -0.03150 + 0.00000 -0.06341 + 0.00371 0.00000 0.09491 +multipole 361 359 357 0.09833 + 0.02571 0.00000 0.16920 + -0.03368 + 0.00000 -0.08428 + 0.00819 0.00000 0.11796 +multipole 362 390 357 -0.53467 + 0.48068 0.00000 -0.09996 + 0.36295 + 0.00000 -0.87560 + -0.49890 0.00000 0.51265 +multipole 363 390 364 -0.52467 + 0.48068 0.00000 -0.09996 + 0.36295 + 0.00000 -0.87560 + -0.49890 0.00000 0.51265 +multipole 364 367 365 0.00960 + 0.00000 0.00000 0.32394 + -0.07147 + 0.00000 -0.07147 + 0.00000 0.00000 0.14294 +multipole 365 364 366 0.07556 + 0.03873 0.00000 0.14751 + -0.08294 + 0.00000 -0.01783 + -0.01217 0.00000 0.10077 +multipole 366 364 365 0.07556 + 0.03873 0.00000 0.14751 + -0.08294 + 0.00000 -0.01783 + -0.01217 0.00000 0.10077 +multipole 367 368 372 0.15826 + 0.24623 0.00000 -0.21242 + 0.08205 + 0.00000 -0.00618 + 0.03696 0.00000 -0.07587 +multipole 368 367 369 0.12800 + 0.02154 0.00000 0.20007 + -0.05590 + 0.00000 -0.00935 + -0.00576 0.00000 0.06525 +multipole 369 370 367 -0.38842 + 0.55727 0.00000 0.37834 + 0.35493 + 0.00000 -1.07262 + -0.43151 0.00000 0.71769 +multipole 370 369 374 0.06720 + 0.26362 0.00000 0.03922 + 0.05443 + 0.00000 -0.09570 + 0.15343 0.00000 0.04127 +multipole 371 370 369 0.12287 + 0.02353 0.00000 0.19270 + -0.05515 + 0.00000 -0.01305 + -0.02241 0.00000 0.06820 +multipole 372 367 374 0.07060 + 0.28362 0.00000 0.21969 + 0.09901 + 0.00000 0.02642 + 0.14299 0.00000 -0.12543 +multipole 373 372 367 0.10297 + -0.00352 0.00000 0.21211 + -0.04895 + 0.00000 -0.01013 + -0.01963 0.00000 0.05908 +multipole 374 372 370 -0.10232 + 0.30155 0.00000 0.23708 + 0.03425 + 0.00000 -0.14123 + 0.16905 0.00000 0.10698 +multipole 375 374 372 0.10225 + 0.01188 0.00000 0.17915 + -0.03150 + 0.00000 -0.06341 + 0.00371 0.00000 0.09491 +multipole 376 374 372 0.09833 + 0.02571 0.00000 0.16920 + -0.03368 + 0.00000 -0.08428 + 0.00819 0.00000 0.11796 +multipole 377 390 372 -0.53467 + 0.48068 0.00000 -0.09996 + 0.36295 + 0.00000 -0.87560 + -0.49890 0.00000 0.51265 +multipole 378 379 -379 0.90070 + 0.00000 0.00000 -0.38892 + 0.04278 + 0.00000 0.04278 + 0.00000 0.00000 -0.08556 +multipole 379 378 379 -0.62196 + -0.02485 0.00000 0.23676 + -0.53745 + 0.00000 -0.44509 + -0.09945 0.00000 0.98254 +multipole 380 317 381 -0.53491 + 0.20945 0.00000 0.45595 + 0.31894 + 0.00000 -0.99741 + -0.33409 0.00000 0.67847 +multipole 380 333 381 -0.53491 + 0.20945 0.00000 0.45595 + 0.31894 + 0.00000 -0.99741 + -0.33409 0.00000 0.67847 +multipole 381 380 333 0.34636 + 0.05168 0.00000 0.21326 + -0.04514 + 0.00000 -0.08116 + -0.01807 0.00000 0.12630 +multipole 381 380 317 0.34636 + 0.05168 0.00000 0.21326 + -0.04514 + 0.00000 -0.08116 + -0.01807 0.00000 0.12630 +multipole 382 383 317 -0.58166 + 0.26215 0.00000 0.04328 + 0.24279 + 0.00000 -0.44387 + -0.22260 0.00000 0.20108 +multipole 382 383 333 -0.58166 + 0.26215 0.00000 0.04328 + 0.24279 + 0.00000 -0.44387 + -0.22260 0.00000 0.20108 +multipole 383 382 384 1.02369 + 0.00000 0.00000 -0.21311 + -0.08100 + 0.00000 -0.08100 + 0.00000 0.00000 0.16200 +multipole 384 383 382 -0.87686 + -0.08747 0.00000 0.03991 + -0.45917 + 0.00000 -0.64191 + 0.17008 0.00000 1.10108 +multipole 385 325 386 -0.50819 + 0.18120 0.00000 0.42418 + 0.28893 + 0.00000 -1.01628 + -0.48824 0.00000 0.72735 +multipole 385 341 386 -0.50819 + 0.18120 0.00000 0.42418 + 0.28893 + 0.00000 -1.01628 + -0.48824 0.00000 0.72735 +multipole 386 385 325 0.29418 + 0.02971 0.00000 0.13453 + -0.01165 + 0.00000 -0.09373 + 0.01341 0.00000 0.10538 +multipole 386 385 341 0.29418 + 0.02971 0.00000 0.13453 + -0.01165 + 0.00000 -0.09373 + 0.01341 0.00000 0.10538 +multipole 387 388 325 -0.60712 + 0.26215 0.00000 0.04328 + 0.24279 + 0.00000 -0.44387 + -0.22260 0.00000 0.20108 +multipole 387 388 341 -0.60712 + 0.26215 0.00000 0.04328 + 0.24279 + 0.00000 -0.44387 + -0.22260 0.00000 0.20108 +multipole 388 387 389 1.02369 + 0.00000 0.00000 -0.21311 + -0.08100 + 0.00000 -0.08100 + 0.00000 0.00000 0.16200 +multipole 389 388 387 -0.87686 + -0.08747 0.00000 0.03991 + -0.45917 + 0.00000 -0.64191 + 0.17008 0.00000 1.10108 +multipole 390 -391 -391 0.90070 + 0.00000 0.00000 -0.38892 + 0.04278 + 0.00000 0.04278 + 0.00000 0.00000 -0.08556 +multipole 391 390 391 -0.62196 + -0.02485 0.00000 0.23676 + -0.53745 + 0.00000 -0.44509 + -0.09945 0.00000 0.98254 +multipole 392 349 393 -0.53491 + 0.20945 0.00000 0.45595 + 0.31894 + 0.00000 -0.99741 + -0.33409 0.00000 0.67847 +multipole 392 364 393 -0.53491 + 0.20945 0.00000 0.45595 + 0.31894 + 0.00000 -0.99741 + -0.33409 0.00000 0.67847 +multipole 393 392 349 0.34636 + 0.05168 0.00000 0.21326 + -0.04514 + 0.00000 -0.08116 + -0.01807 0.00000 0.12630 +multipole 393 392 364 0.34636 + 0.05168 0.00000 0.21326 + -0.04514 + 0.00000 -0.08116 + -0.01807 0.00000 0.12630 +multipole 394 395 349 -0.58166 + 0.26215 0.00000 0.04328 + 0.24279 + 0.00000 -0.44387 + -0.22260 0.00000 0.20108 +multipole 394 395 364 -0.58166 + 0.26215 0.00000 0.04328 + 0.24279 + 0.00000 -0.44387 + -0.22260 0.00000 0.20108 +multipole 395 394 396 1.02369 + 0.00000 0.00000 -0.21311 + -0.08100 + 0.00000 -0.08100 + 0.00000 0.00000 0.16200 +multipole 396 395 394 -0.87686 + -0.08747 0.00000 0.03991 + -0.45917 + 0.00000 -0.64191 + 0.17008 0.00000 1.10108 +multipole 397 357 398 -0.50819 + 0.18120 0.00000 0.42418 + 0.28893 + 0.00000 -1.01628 + -0.48824 0.00000 0.72735 +multipole 397 372 398 -0.50819 + 0.18120 0.00000 0.42418 + 0.28893 + 0.00000 -1.01628 + -0.48824 0.00000 0.72735 +multipole 398 397 357 0.29418 + 0.02971 0.00000 0.13453 + -0.01165 + 0.00000 -0.09373 + 0.01341 0.00000 0.10538 +multipole 398 397 372 0.29418 + 0.02971 0.00000 0.13453 + -0.01165 + 0.00000 -0.09373 + 0.01341 0.00000 0.10538 +multipole 399 400 357 -0.60712 + 0.26215 0.00000 0.04328 + 0.24279 + 0.00000 -0.44387 + -0.22260 0.00000 0.20108 +multipole 399 400 372 -0.60712 + 0.26215 0.00000 0.04328 + 0.24279 + 0.00000 -0.44387 + -0.22260 0.00000 0.20108 +multipole 400 399 401 1.02369 + 0.00000 0.00000 -0.21311 + -0.08100 + 0.00000 -0.08100 + 0.00000 0.00000 0.16200 +multipole 401 400 399 -0.87686 + -0.08747 0.00000 0.03991 + -0.45917 + 0.00000 -0.64191 + 0.17008 0.00000 1.10108 +multipole 402 -403 -403 -0.51966 + 0.00000 0.00000 0.14279 + 0.37928 + 0.00000 -0.41809 + 0.00000 0.00000 0.03881 +multipole 403 402 403 0.25983 + -0.03859 0.00000 -0.05818 + -0.03673 + 0.00000 -0.10739 + -0.00203 0.00000 0.14412 +multipole 404 0 0 1.00000 + 0.00000 0.00000 0.00000 + 0.00000 + 0.00000 0.00000 + 0.00000 0.00000 0.00000 +multipole 405 0 0 1.00000 + 0.00000 0.00000 0.00000 + 0.00000 + 0.00000 0.00000 + 0.00000 0.00000 0.00000 +multipole 406 0 0 1.00000 + 0.00000 0.00000 0.00000 + 0.00000 + 0.00000 0.00000 + 0.00000 0.00000 0.00000 +multipole 407 0 0 1.00000 + 0.00000 0.00000 0.00000 + 0.00000 + 0.00000 0.00000 + 0.00000 0.00000 0.00000 +multipole 408 0 0 1.00000 + 0.00000 0.00000 0.00000 + 0.00000 + 0.00000 0.00000 + 0.00000 0.00000 0.00000 +multipole 409 0 0 2.00000 + 0.00000 0.00000 0.00000 + 0.00000 + 0.00000 0.00000 + 0.00000 0.00000 0.00000 +multipole 410 0 0 2.00000 + 0.00000 0.00000 0.00000 + 0.00000 + 0.00000 0.00000 + 0.00000 0.00000 0.00000 +multipole 411 0 0 2.00000 + 0.00000 0.00000 0.00000 + 0.00000 + 0.00000 0.00000 + 0.00000 0.00000 0.00000 +multipole 412 0 0 2.00000 + 0.00000 0.00000 0.00000 + 0.00000 + 0.00000 0.00000 + 0.00000 0.00000 0.00000 +multipole 413 0 0 -1.00000 + 0.00000 0.00000 0.00000 + 0.00000 + 0.00000 0.00000 + 0.00000 0.00000 0.00000 +multipole 414 0 0 -1.00000 + 0.00000 0.00000 0.00000 + 0.00000 + 0.00000 0.00000 + 0.00000 0.00000 0.00000 +multipole 415 0 0 -1.00000 + 0.00000 0.00000 0.00000 + 0.00000 + 0.00000 0.00000 + 0.00000 0.00000 0.00000 +multipole 416 0 0 -1.00000 + 0.00000 0.00000 0.00000 + 0.00000 + 0.00000 0.00000 + 0.00000 0.00000 0.00000 + + + ######################################## + ## ## + ## Dipole Polarizability Parameters ## + ## ## + ######################################## + + +polarize 1 1.0730 0.3900 3 4 9 55 226 247 +polarize 2 1.3340 0.3900 6 +polarize 3 1.3340 0.3900 1 5 7 53 228 230 +polarize 4 0.4960 0.3900 1 +polarize 5 0.8370 0.3900 3 +polarize 6 0.4960 0.3900 2 +polarize 7 1.0730 0.3900 3 9 10 55 226 247 +polarize 8 1.3340 0.3900 12 +polarize 9 1.3340 0.3900 1 7 11 53 228 230 +polarize 10 0.4960 0.3900 7 +polarize 11 0.8370 0.3900 9 +polarize 12 0.4960 0.3900 8 33 44 +polarize 13 1.3340 0.3900 14 +polarize 14 0.4960 0.3900 13 +polarize 15 1.3340 0.3900 16 +polarize 16 0.4960 0.3900 15 +polarize 17 1.3340 0.3900 18 +polarize 18 0.4960 0.3900 17 +polarize 19 1.3340 0.3900 20 +polarize 20 0.4960 0.3900 19 +polarize 21 1.3340 0.3900 22 +polarize 22 0.4960 0.3900 21 +polarize 23 1.3340 0.3900 24 +polarize 24 0.4960 0.3900 23 +polarize 25 1.3340 0.3900 26 +polarize 26 0.4960 0.3900 25 +polarize 27 1.3340 0.3900 28 +polarize 28 0.4960 0.3900 27 +polarize 29 1.3340 0.3900 30 +polarize 30 0.4960 0.3900 29 +polarize 31 1.3340 0.3900 32 +polarize 32 0.4960 0.3900 31 +polarize 33 1.3340 0.3900 12 +polarize 34 1.3340 0.3900 35 36 +polarize 35 0.4960 0.3900 34 +polarize 36 0.8340 0.3900 34 37 +polarize 37 0.4960 0.3900 36 +polarize 38 1.3340 0.3900 39 42 +polarize 39 0.4960 0.3900 38 +polarize 40 1.3340 0.3900 41 +polarize 41 0.4960 0.3900 40 +polarize 42 0.8340 0.3900 38 43 +polarize 43 0.4960 0.3900 42 +polarize 44 1.3340 0.3900 12 +polarize 45 1.3340 0.3900 46 47 49 +polarize 46 0.4960 0.3900 45 +polarize 47 3.3000 0.3900 45 48 +polarize 48 0.4960 0.3900 47 +polarize 49 3.3000 0.3900 45 49 +polarize 50 1.3340 0.3900 51 52 +polarize 51 0.4960 0.3900 50 +polarize 52 3.3000 0.3900 50 +polarize 53 1.0730 0.3900 3 9 55 62 226 247 +polarize 54 1.3340 0.3900 57 +polarize 55 1.3340 0.3900 1 7 53 56 228 230 +polarize 56 0.8370 0.3900 55 +polarize 57 0.4960 0.3900 54 +polarize 58 1.3340 0.3900 59 +polarize 59 0.4960 0.3900 58 +polarize 60 1.3340 0.3900 61 +polarize 61 0.4960 0.3900 60 +polarize 62 1.3340 0.3900 53 63 +polarize 63 0.4960 0.3900 62 +polarize 64 1.3340 0.3900 65 +polarize 65 0.4960 0.3900 64 +polarize 66 1.7500 0.3900 67 +polarize 67 1.7500 0.3900 66 68 69 +polarize 68 0.6960 0.3900 67 +polarize 69 1.7500 0.3900 67 70 71 +polarize 70 0.6960 0.3900 69 +polarize 71 1.7500 0.3900 69 72 +polarize 72 0.6960 0.3900 71 +polarize 73 1.3340 0.3900 74 +polarize 74 0.4960 0.3900 73 +polarize 75 1.7500 0.3900 76 +polarize 76 1.7500 0.3900 75 77 78 +polarize 77 0.6960 0.3900 76 +polarize 78 1.7500 0.3900 76 79 80 +polarize 79 0.6960 0.3900 78 +polarize 80 1.7500 0.3900 78 81 +polarize 81 0.8730 0.3900 80 82 +polarize 82 0.4960 0.3900 81 +polarize 83 1.3340 0.3900 84 +polarize 84 0.4960 0.3900 83 +polarize 85 1.7500 0.3900 86 +polarize 86 1.7500 0.3900 85 87 88 +polarize 87 0.6960 0.3900 86 +polarize 88 1.7500 0.3900 86 89 90 +polarize 89 0.6960 0.3900 88 +polarize 90 1.7500 0.3900 88 91 +polarize 91 0.8370 0.3900 90 +polarize 92 1.3340 0.3900 93 +polarize 93 0.4960 0.3900 92 +polarize 94 1.7500 0.3900 95 97 +polarize 95 1.7500 0.3900 94 96 98 +polarize 96 0.6960 0.3900 95 +polarize 97 1.7500 0.3900 94 100 101 +polarize 98 1.0730 0.3900 95 99 100 +polarize 99 0.4960 0.3900 98 +polarize 100 1.7500 0.3900 97 98 103 +polarize 101 1.7500 0.3900 97 102 105 +polarize 102 0.6960 0.3900 101 +polarize 103 1.7500 0.3900 100 104 107 +polarize 104 0.6960 0.3900 103 +polarize 105 1.7500 0.3900 101 106 107 +polarize 106 0.6960 0.3900 105 +polarize 107 1.7500 0.3900 103 105 108 +polarize 108 0.6960 0.3900 107 +polarize 109 1.3340 0.3900 110 +polarize 110 0.4960 0.3900 109 +polarize 111 1.7500 0.3900 112 114 +polarize 112 1.0730 0.3900 111 113 116 +polarize 113 0.4960 0.3900 112 +polarize 114 1.7500 0.3900 111 115 118 +polarize 115 0.6960 0.3900 114 +polarize 116 1.7500 0.3900 112 117 118 +polarize 117 0.6960 0.3900 116 +polarize 118 1.0730 0.3900 114 116 119 +polarize 119 0.4960 0.3900 118 +polarize 120 1.3340 0.3900 121 +polarize 121 0.4960 0.3900 120 +polarize 122 1.7500 0.3900 123 125 +polarize 123 1.0730 0.3900 122 124 127 +polarize 124 0.4960 0.3900 123 +polarize 125 1.7500 0.3900 122 126 129 +polarize 126 0.6960 0.3900 125 +polarize 127 1.7500 0.3900 123 128 129 +polarize 128 0.6960 0.3900 127 +polarize 129 1.0730 0.3900 125 127 +polarize 130 1.3340 0.3900 131 +polarize 131 0.4960 0.3900 130 +polarize 132 1.7500 0.3900 133 134 +polarize 133 1.0730 0.3900 132 136 +polarize 134 1.7500 0.3900 132 135 138 +polarize 135 0.6960 0.3900 134 +polarize 136 1.7500 0.3900 133 137 138 +polarize 137 0.6960 0.3900 136 +polarize 138 1.0730 0.3900 134 136 139 +polarize 139 0.4960 0.3900 138 +polarize 140 1.3340 0.3900 141 +polarize 141 0.4960 0.3900 140 +polarize 142 1.3340 0.3900 143 +polarize 143 0.8370 0.3900 142 +polarize 144 1.3340 0.3900 145 +polarize 145 0.4960 0.3900 144 +polarize 146 1.3340 0.3900 147 148 +polarize 147 0.8370 0.3900 146 +polarize 148 0.8370 0.3900 146 149 +polarize 149 0.4960 0.3900 148 +polarize 150 1.3340 0.3900 151 +polarize 151 0.4960 0.3900 150 +polarize 152 1.3340 0.3900 153 154 +polarize 153 0.8340 0.3900 152 +polarize 154 1.0730 0.3900 152 155 +polarize 155 0.4960 0.3900 154 +polarize 156 1.3340 0.3900 157 +polarize 157 0.4960 0.3900 156 +polarize 158 1.3340 0.3900 159 +polarize 159 0.4960 0.3900 158 +polarize 160 1.3340 0.3900 161 +polarize 161 0.8370 0.3900 160 +polarize 162 1.3340 0.3900 163 +polarize 163 0.4960 0.3900 162 +polarize 164 1.3340 0.3900 165 +polarize 165 0.4960 0.3900 164 +polarize 166 1.3340 0.3900 167 168 +polarize 167 0.8370 0.3900 166 +polarize 168 0.8370 0.3900 166 169 +polarize 169 0.4960 0.3900 168 +polarize 170 1.3340 0.3900 171 +polarize 171 0.4960 0.3900 170 +polarize 172 1.3340 0.3900 173 +polarize 173 0.4960 0.3900 172 +polarize 174 1.3340 0.3900 175 176 +polarize 175 0.8340 0.3900 174 +polarize 176 1.0730 0.3900 174 177 +polarize 177 0.4960 0.3900 176 +polarize 178 1.3340 0.3900 179 +polarize 179 0.4960 0.3900 178 +polarize 180 1.3340 0.3900 181 182 +polarize 181 0.4960 0.3900 180 +polarize 182 3.3000 0.3900 180 183 +polarize 183 1.3340 0.3900 182 184 +polarize 184 0.4960 0.3900 183 +polarize 185 1.3340 0.3900 186 +polarize 186 0.4960 0.3900 185 +polarize 187 1.3340 0.3900 188 +polarize 188 0.4960 0.3900 187 +polarize 189 1.3340 0.3900 190 +polarize 190 0.4960 0.3900 189 +polarize 191 1.3340 0.3900 192 +polarize 192 0.4960 0.3900 191 +polarize 193 1.0730 0.3900 194 +polarize 195 1.3340 0.3900 196 +polarize 196 0.4960 0.3900 195 +polarize 197 1.3340 0.3900 198 +polarize 198 0.4960 0.3900 197 +polarize 194 0.4960 0.3900 193 +polarize 199 1.3340 0.3900 200 +polarize 200 0.4960 0.3900 199 +polarize 201 1.3340 0.3900 202 203 +polarize 202 0.4960 0.3900 201 +polarize 203 1.0730 0.3900 201 204 +polarize 204 0.4960 0.3900 203 +polarize 205 1.3340 0.3900 206 +polarize 206 0.4960 0.3900 205 +polarize 207 1.3340 0.3900 208 +polarize 208 0.4960 0.3900 207 +polarize 209 1.3340 0.3900 210 211 +polarize 210 0.4960 0.3900 209 +polarize 211 1.0730 0.3900 209 212 213 +polarize 212 0.4960 0.3900 211 +polarize 213 1.3340 0.3900 211 214 +polarize 214 1.0730 0.3900 213 215 +polarize 215 0.4960 0.3900 214 +polarize 216 1.3340 0.3900 217 +polarize 217 0.4960 0.3900 216 +polarize 218 1.3340 0.3900 219 +polarize 219 0.4960 0.3900 218 +polarize 220 1.3340 0.3900 221 +polarize 221 0.4960 0.3900 220 +polarize 222 1.0730 0.3900 223 +polarize 223 0.4960 0.3900 222 +polarize 224 1.3340 0.3900 225 +polarize 225 0.4960 0.3900 224 +polarize 226 1.3340 0.3900 1 7 53 227 +polarize 227 0.8370 0.3900 226 +polarize 228 1.0730 0.3900 3 9 55 229 247 +polarize 229 0.4960 0.3900 228 +polarize 230 1.0730 0.3900 3 9 55 231 247 +polarize 231 0.4960 0.3900 230 +polarize 232 1.3340 0.3900 233 +polarize 233 0.4960 0.3900 232 +polarize 234 1.0730 0.3900 235 +polarize 235 0.4960 0.3900 234 +polarize 236 1.0730 0.3900 237 +polarize 237 0.4960 0.3900 236 +polarize 238 1.3340 0.3900 239 +polarize 239 0.8370 0.3900 238 +polarize 240 1.3340 0.3900 241 242 +polarize 241 0.8370 0.3900 240 +polarize 242 0.8370 0.3900 240 243 +polarize 243 0.4960 0.3900 242 +polarize 244 1.0730 0.3900 245 +polarize 245 0.4960 0.3900 244 +polarize 246 1.3340 0.3900 249 +polarize 247 1.3340 0.3900 1 7 53 228 230 248 +polarize 248 0.8370 0.3900 247 +polarize 249 0.4960 0.3900 246 +polarize 250 1.3340 0.3900 251 +polarize 251 0.4960 0.3900 250 +polarize 252 1.0730 0.3900 253 256 +polarize 253 1.7500 0.3900 252 254 257 +polarize 254 1.7500 0.3900 253 255 260 +polarize 255 1.0730 0.3900 254 256 +polarize 256 1.7500 0.3900 252 255 265 +polarize 257 1.0730 0.3900 253 258 +polarize 258 1.7500 0.3900 257 259 261 +polarize 259 1.0730 0.3900 258 260 +polarize 260 1.7500 0.3900 254 259 +polarize 261 0.6960 0.3900 258 +polarize 262 1.0730 0.3900 263 264 +polarize 263 0.4960 0.3900 262 +polarize 264 0.4960 0.3900 262 +polarize 265 0.6960 0.3900 256 +polarize 266 1.0730 0.3900 267 271 +polarize 267 1.7500 0.3900 266 268 272 +polarize 268 1.0730 0.3900 267 269 +polarize 269 1.7500 0.3900 268 270 +polarize 270 1.7500 0.3900 269 271 276 +polarize 271 1.7500 0.3900 266 270 277 +polarize 272 0.8370 0.3900 267 +polarize 273 1.0730 0.3900 274 275 +polarize 274 0.4960 0.3900 273 +polarize 275 0.4960 0.3900 273 +polarize 276 0.6960 0.3900 270 +polarize 277 0.6960 0.3900 271 +polarize 278 1.0730 0.3900 279 282 +polarize 279 1.7500 0.3900 278 280 283 +polarize 280 1.7500 0.3900 279 281 286 +polarize 281 1.0730 0.3900 280 282 +polarize 282 1.7500 0.3900 278 281 292 +polarize 283 1.0730 0.3900 279 284 +polarize 284 1.7500 0.3900 283 285 +polarize 285 1.0730 0.3900 284 286 287 +polarize 286 1.7500 0.3900 280 285 291 +polarize 287 0.6960 0.3900 285 +polarize 288 1.0730 0.3900 289 290 +polarize 289 0.4960 0.3900 288 +polarize 290 0.4960 0.3900 288 +polarize 291 0.8370 0.3900 286 +polarize 292 0.6960 0.3900 282 +polarize 293 1.0730 0.3900 294 298 +polarize 294 1.7500 0.3900 293 295 299 +polarize 295 1.0730 0.3900 294 296 300 +polarize 296 1.7500 0.3900 295 297 301 +polarize 297 1.7500 0.3900 296 298 +polarize 298 1.7500 0.3900 293 297 304 +polarize 299 0.8370 0.3900 294 +polarize 300 0.6960 0.3900 295 +polarize 301 0.8370 0.3900 296 +polarize 302 1.3340 0.3900 303 +polarize 303 0.4960 0.3900 302 +polarize 304 0.6960 0.3900 298 +polarize 305 1.0730 0.3900 306 310 +polarize 306 1.7500 0.3900 305 307 311 +polarize 307 1.0730 0.3900 306 308 312 +polarize 308 1.7500 0.3900 307 309 313 +polarize 309 1.7500 0.3900 308 310 314 +polarize 310 1.7500 0.3900 305 309 315 +polarize 311 0.8370 0.3900 306 +polarize 312 0.4960 0.3900 307 +polarize 313 0.8370 0.3900 308 +polarize 314 0.6960 0.3900 309 +polarize 315 0.6960 0.3900 310 +polarize 316 0.8370 0.3900 378 +polarize 317 1.3340 0.3900 318 319 +polarize 318 0.4960 0.3900 317 +polarize 319 0.4960 0.3900 317 +polarize 320 1.3340 0.3900 321 +polarize 321 0.4960 0.3900 320 +polarize 322 0.8370 0.3900 +polarize 323 1.3340 0.3900 324 +polarize 324 0.4960 0.3900 323 +polarize 325 1.3340 0.3900 326 +polarize 326 0.4960 0.3900 325 +polarize 327 1.3340 0.3900 328 329 330 +polarize 328 0.4960 0.3900 327 +polarize 329 1.3340 0.3900 327 330 +polarize 330 0.4960 0.3900 329 +polarize 331 0.8370 0.3900 378 +polarize 332 0.8370 0.3900 378 +polarize 333 1.3340 0.3900 334 335 +polarize 334 0.4960 0.3900 333 +polarize 335 0.4960 0.3900 333 +polarize 336 1.3340 0.3900 337 +polarize 337 0.4960 0.3900 336 +polarize 338 0.8370 0.3900 +polarize 339 1.3340 0.3900 340 +polarize 340 0.4960 0.3900 339 +polarize 341 1.3340 0.3900 342 +polarize 342 0.4960 0.3900 341 +polarize 343 1.3340 0.3900 344 345 346 +polarize 344 0.4960 0.3900 343 +polarize 345 1.3340 0.3900 343 346 +polarize 346 0.4960 0.3900 345 +polarize 347 0.8370 0.3900 378 +polarize 348 0.8370 0.3900 390 +polarize 349 1.3340 0.3900 350 351 +polarize 350 0.4960 0.3900 349 +polarize 351 0.4960 0.3900 349 +polarize 352 1.3340 0.3900 353 +polarize 353 0.4960 0.3900 352 +polarize 354 0.8370 0.3900 +polarize 355 1.3340 0.3900 356 +polarize 356 0.4960 0.3900 355 +polarize 357 1.3340 0.3900 358 +polarize 358 0.4960 0.3900 357 +polarize 359 1.3340 0.3900 360 361 +polarize 360 0.4960 0.3900 359 +polarize 361 0.4960 0.3900 359 +polarize 362 0.8370 0.3900 390 +polarize 363 0.8370 0.3900 390 +polarize 364 1.3340 0.3900 365 366 +polarize 365 0.4960 0.3900 364 +polarize 366 0.4960 0.3900 364 +polarize 367 1.3340 0.3900 368 +polarize 368 0.4960 0.3900 367 +polarize 369 0.8370 0.3900 +polarize 370 1.3340 0.3900 371 +polarize 371 0.4960 0.3900 370 +polarize 372 1.3340 0.3900 373 +polarize 373 0.4960 0.3900 372 +polarize 374 1.3340 0.3900 375 376 +polarize 375 0.4960 0.3900 374 +polarize 376 0.4960 0.3900 374 +polarize 377 0.8370 0.3900 390 +polarize 378 1.8280 0.3900 316 331 332 347 379 +polarize 379 0.8370 0.3900 378 +polarize 380 0.8370 0.3900 381 +polarize 381 0.4960 0.3900 380 +polarize 382 0.8370 0.3900 +polarize 383 1.8280 0.3900 384 +polarize 384 0.8370 0.3900 383 +polarize 385 0.8370 0.3900 386 +polarize 386 0.4960 0.3900 385 +polarize 387 0.8370 0.3900 +polarize 388 1.8280 0.3900 389 +polarize 389 0.8370 0.3900 388 +polarize 390 1.8280 0.3900 348 362 363 377 391 +polarize 391 0.8370 0.3900 390 +polarize 392 0.8370 0.3900 393 +polarize 393 0.4960 0.3900 392 +polarize 394 0.8370 0.3900 +polarize 395 1.8280 0.3900 396 +polarize 396 0.8370 0.3900 395 +polarize 397 0.8370 0.3900 398 +polarize 398 0.4960 0.3900 397 +polarize 399 0.8370 0.3900 +polarize 400 1.8280 0.3900 401 +polarize 401 0.8370 0.3900 400 +polarize 402 0.8370 0.3900 403 +polarize 403 0.4960 0.3900 402 +polarize 404 0.0280 0.3900 +polarize 405 0.1200 0.3900 +polarize 406 0.7800 0.3900 +polarize 407 1.3500 0.3900 +polarize 408 2.2600 0.3900 +polarize 409 0.0100 0.0650 +polarize 410 0.0800 0.0952 +polarize 411 0.5500 0.1585 +polarize 412 0.2600 0.2096 +polarize 413 1.3500 0.3900 +polarize 414 4.0000 0.3900 +polarize 415 5.6500 0.3900 +polarize 416 7.2500 0.3900 + + + ######################################## + ## ## + ## Biopolymer Atom Type Conversions ## + ## ## + ######################################## + + +biotype 1 N "Glycine" 1 +biotype 2 CA "Glycine" 2 +biotype 3 C "Glycine" 3 +biotype 4 HN "Glycine" 4 +biotype 5 O "Glycine" 5 +biotype 6 HA "Glycine" 6 +biotype 7 N "Alanine" 7 +biotype 8 CA "Alanine" 8 +biotype 9 C "Alanine" 9 +biotype 10 HN "Alanine" 10 +biotype 11 O "Alanine" 11 +biotype 12 HA "Alanine" 12 +biotype 13 CB "Alanine" 13 +biotype 14 HB "Alanine" 14 +biotype 15 N "Valine" 7 +biotype 16 CA "Valine" 8 +biotype 17 C "Valine" 9 +biotype 18 HN "Valine" 10 +biotype 19 O "Valine" 11 +biotype 20 HA "Valine" 12 +biotype 21 CB "Valine" 15 +biotype 22 HB "Valine" 16 +biotype 23 CG1 "Valine" 17 +biotype 24 HG1 "Valine" 18 +biotype 25 CG2 "Valine" 17 +biotype 26 HG2 "Valine" 18 +biotype 27 N "Leucine" 7 +biotype 28 CA "Leucine" 8 +biotype 29 C "Leucine" 9 +biotype 30 HN "Leucine" 10 +biotype 31 O "Leucine" 11 +biotype 32 HA "Leucine" 12 +biotype 33 CB "Leucine" 19 +biotype 34 HB "Leucine" 20 +biotype 35 CG "Leucine" 21 +biotype 36 HG "Leucine" 22 +biotype 37 CD1 "Leucine" 23 +biotype 38 HD1 "Leucine" 24 +biotype 39 CD2 "Leucine" 23 +biotype 40 HD2 "Leucine" 24 +biotype 41 N "Isoleucine" 7 +biotype 42 CA "Isoleucine" 8 +biotype 43 C "Isoleucine" 9 +biotype 44 HN "Isoleucine" 10 +biotype 45 O "Isoleucine" 11 +biotype 46 HA "Isoleucine" 12 +biotype 47 CB "Isoleucine" 25 +biotype 48 HB "Isoleucine" 26 +biotype 49 CG1 "Isoleucine" 29 +biotype 50 HG1 "Isoleucine" 30 +biotype 51 CG2 "Isoleucine" 27 +biotype 52 HG2 "Isoleucine" 28 +biotype 53 CD "Isoleucine" 31 +biotype 54 HD "Isoleucine" 32 +biotype 55 N "Serine" 7 +biotype 56 CA "Serine" 33 +biotype 57 C "Serine" 9 +biotype 58 HN "Serine" 10 +biotype 59 O "Serine" 11 +biotype 60 HA "Serine" 12 +biotype 61 CB "Serine" 34 +biotype 62 HB "Serine" 35 +biotype 63 OG "Serine" 36 +biotype 64 HG "Serine" 37 +biotype 65 N "Threonine" 7 +biotype 66 CA "Threonine" 33 +biotype 67 C "Threonine" 9 +biotype 68 HN "Threonine" 10 +biotype 69 O "Threonine" 11 +biotype 70 HA "Threonine" 12 +biotype 71 CB "Threonine" 38 +biotype 72 HB "Threonine" 39 +biotype 73 OG1 "Threonine" 42 +biotype 74 HG1 "Threonine" 43 +biotype 75 CG2 "Threonine" 40 +biotype 76 HG2 "Threonine" 41 +biotype 77 N "Cysteine (SH)" 7 +biotype 78 CA "Cysteine (SH)" 44 +biotype 79 C "Cysteine (SH)" 9 +biotype 80 HN "Cysteine (SH)" 10 +biotype 81 O "Cysteine (SH)" 11 +biotype 82 HA "Cysteine (SH)" 12 +biotype 83 CB "Cysteine (SH)" 45 +biotype 84 HB "Cysteine (SH)" 46 +biotype 85 SG "Cysteine (SH)" 47 +biotype 86 HG "Cysteine (SH)" 48 +biotype 87 N "Cystine (SS)" 7 +biotype 88 CA "Cystine (SS)" 44 +biotype 89 C "Cystine (SS)" 9 +biotype 90 HN "Cystine (SS)" 10 +biotype 91 O "Cystine (SS)" 11 +biotype 92 HA "Cystine (SS)" 12 +biotype 93 CB "Cystine (SS)" 45 +biotype 94 HB "Cystine (SS)" 46 +biotype 95 SG "Cystine (SS)" 49 +biotype 96 N "Cysteine (S-)" 7 +biotype 97 CA "Cysteine (S-)" 44 +biotype 98 C "Cysteine (S-)" 9 +biotype 99 HN "Cysteine (S-)" 10 +biotype 100 O "Cysteine (S-)" 11 +biotype 101 HA "Cysteine (S-)" 12 +biotype 102 CB "Cysteine (S-)" 50 +biotype 103 HB "Cysteine (S-)" 51 +biotype 104 SG "Cysteine (S-)" 52 +biotype 105 N "Proline" 53 +biotype 106 CA "Proline" 54 +biotype 107 C "Proline" 55 +biotype 108 O "Proline" 56 +biotype 109 HA "Proline" 57 +biotype 110 CB "Proline" 58 +biotype 111 HB "Proline" 59 +biotype 112 CG "Proline" 60 +biotype 113 HG "Proline" 61 +biotype 114 CD "Proline" 62 +biotype 115 HD "Proline" 63 +biotype 116 N "Phenylalanine" 7 +biotype 117 CA "Phenylalanine" 8 +biotype 118 C "Phenylalanine" 9 +biotype 119 HN "Phenylalanine" 10 +biotype 120 O "Phenylalanine" 11 +biotype 121 HA "Phenylalanine" 12 +biotype 122 CB "Phenylalanine" 64 +biotype 123 HB "Phenylalanine" 65 +biotype 124 CG "Phenylalanine" 66 +biotype 125 CD "Phenylalanine" 67 +biotype 126 HD "Phenylalanine" 68 +biotype 127 CE "Phenylalanine" 69 +biotype 128 HE "Phenylalanine" 70 +biotype 129 CZ "Phenylalanine" 71 +biotype 130 HZ "Phenylalanine" 72 +biotype 131 N "Tyrosine" 7 +biotype 132 CA "Tyrosine" 8 +biotype 133 C "Tyrosine" 9 +biotype 134 HN "Tyrosine" 10 +biotype 135 O "Tyrosine" 11 +biotype 136 HA "Tyrosine" 12 +biotype 137 CB "Tyrosine" 73 +biotype 138 HB "Tyrosine" 74 +biotype 139 CG "Tyrosine" 75 +biotype 140 CD "Tyrosine" 76 +biotype 141 HD "Tyrosine" 77 +biotype 142 CE "Tyrosine" 78 +biotype 143 HE "Tyrosine" 79 +biotype 144 CZ "Tyrosine" 80 +biotype 145 OH "Tyrosine" 81 +biotype 146 HH "Tyrosine" 82 +biotype 147 N "Tyrosine (O-)" 7 +biotype 148 CA "Tyrosine (O-)" 8 +biotype 149 C "Tyrosine (O-)" 9 +biotype 150 HN "Tyrosine (O-)" 10 +biotype 151 O "Tyrosine (O-)" 11 +biotype 152 HA "Tyrosine (O-)" 12 +biotype 153 CB "Tyrosine (O-)" 83 +biotype 154 HB "Tyrosine (O-)" 84 +biotype 155 CG "Tyrosine (O-)" 85 +biotype 156 CD "Tyrosine (O-)" 86 +biotype 157 HD "Tyrosine (O-)" 87 +biotype 158 CE "Tyrosine (O-)" 88 +biotype 159 HE "Tyrosine (O-)" 89 +biotype 160 CZ "Tyrosine (O-)" 90 +biotype 161 OH "Tyrosine (O-)" 91 +biotype 162 N "Tryptophan" 7 +biotype 163 CA "Tryptophan" 8 +biotype 164 C "Tryptophan" 9 +biotype 165 HN "Tryptophan" 10 +biotype 166 O "Tryptophan" 11 +biotype 167 HA "Tryptophan" 12 +biotype 168 CB "Tryptophan" 92 +biotype 169 HB "Tryptophan" 93 +biotype 170 CG "Tryptophan" 94 +biotype 171 CD1 "Tryptophan" 95 +biotype 172 HD1 "Tryptophan" 96 +biotype 173 CD2 "Tryptophan" 97 +biotype 174 NE1 "Tryptophan" 98 +biotype 175 HE1 "Tryptophan" 99 +biotype 176 CE2 "Tryptophan" 100 +biotype 177 CE3 "Tryptophan" 101 +biotype 178 HE3 "Tryptophan" 102 +biotype 179 CZ2 "Tryptophan" 103 +biotype 180 HZ2 "Tryptophan" 104 +biotype 181 CZ3 "Tryptophan" 105 +biotype 182 HZ3 "Tryptophan" 106 +biotype 183 CH2 "Tryptophan" 107 +biotype 184 HH2 "Tryptophan" 108 +biotype 185 N "Histidine (+)" 7 +biotype 186 CA "Histidine (+)" 8 +biotype 187 C "Histidine (+)" 9 +biotype 188 HN "Histidine (+)" 10 +biotype 189 O "Histidine (+)" 11 +biotype 190 HA "Histidine (+)" 12 +biotype 191 CB "Histidine (+)" 109 +biotype 192 HB "Histidine (+)" 110 +biotype 193 CG "Histidine (+)" 111 +biotype 194 ND1 "Histidine (+)" 112 +biotype 195 HD1 "Histidine (+)" 113 +biotype 196 CD2 "Histidine (+)" 114 +biotype 197 HD2 "Histidine (+)" 115 +biotype 198 CE1 "Histidine (+)" 116 +biotype 199 HE1 "Histidine (+)" 117 +biotype 200 NE2 "Histidine (+)" 118 +biotype 201 HE2 "Histidine (+)" 119 +biotype 202 N "Histidine (HD)" 7 +biotype 203 CA "Histidine (HD)" 8 +biotype 204 C "Histidine (HD)" 9 +biotype 205 HN "Histidine (HD)" 10 +biotype 206 O "Histidine (HD)" 11 +biotype 207 HA "Histidine (HD)" 12 +biotype 208 CB "Histidine (HD)" 120 +biotype 209 HB "Histidine (HD)" 121 +biotype 210 CG "Histidine (HD)" 122 +biotype 211 ND1 "Histidine (HD)" 123 +biotype 212 HD1 "Histidine (HD)" 124 +biotype 213 CD2 "Histidine (HD)" 125 +biotype 214 HD2 "Histidine (HD)" 126 +biotype 215 CE1 "Histidine (HD)" 127 +biotype 216 HE1 "Histidine (HD)" 128 +biotype 217 NE2 "Histidine (HD)" 129 +biotype 218 N "Histidine (HE)" 7 +biotype 219 CA "Histidine (HE)" 8 +biotype 220 C "Histidine (HE)" 9 +biotype 221 HN "Histidine (HE)" 10 +biotype 222 O "Histidine (HE)" 11 +biotype 223 HA "Histidine (HE)" 12 +biotype 224 CB "Histidine (HE)" 130 +biotype 225 HB "Histidine (HE)" 131 +biotype 226 CG "Histidine (HE)" 132 +biotype 227 ND1 "Histidine (HE)" 133 +biotype 228 CD2 "Histidine (HE)" 134 +biotype 229 HD2 "Histidine (HE)" 135 +biotype 230 CE1 "Histidine (HE)" 136 +biotype 231 HE1 "Histidine (HE)" 137 +biotype 232 NE2 "Histidine (HE)" 138 +biotype 233 HE2 "Histidine (HE)" 139 +biotype 234 N "Aspartic Acid" 7 +biotype 235 CA "Aspartic Acid" 8 +biotype 236 C "Aspartic Acid" 9 +biotype 237 HN "Aspartic Acid" 10 +biotype 238 O "Aspartic Acid" 11 +biotype 239 HA "Aspartic Acid" 12 +biotype 240 CB "Aspartic Acid" 140 +biotype 241 HB "Aspartic Acid" 141 +biotype 242 CG "Aspartic Acid" 142 +biotype 243 OD "Aspartic Acid" 143 +biotype 244 N "Aspartic Acid (COOH)" 7 +biotype 245 CA "Aspartic Acid (COOH)" 8 +biotype 246 C "Aspartic Acid (COOH)" 9 +biotype 247 HN "Aspartic Acid (COOH)" 10 +biotype 248 O "Aspartic Acid (COOH)" 11 +biotype 249 HA "Aspartic Acid (COOH)" 12 +biotype 250 CB "Aspartic Acid (COOH)" 144 +biotype 251 HB "Aspartic Acid (COOH)" 145 +biotype 252 CG "Aspartic Acid (COOH)" 146 +biotype 253 OD1 "Aspartic Acid (COOH)" 147 +biotype 254 OD2 "Aspartic Acid (COOH)" 148 +biotype 255 HD2 "Aspartic Acid (COOH)" 149 +biotype 256 N "Asparagine" 7 +biotype 257 CA "Asparagine" 8 +biotype 258 C "Asparagine" 9 +biotype 259 HN "Asparagine" 10 +biotype 260 O "Asparagine" 11 +biotype 261 HA "Asparagine" 12 +biotype 262 CB "Asparagine" 150 +biotype 263 HB "Asparagine" 151 +biotype 264 CG "Asparagine" 152 +biotype 265 OD1 "Asparagine" 153 +biotype 266 ND2 "Asparagine" 154 +biotype 267 HD2 "Asparagine" 155 +biotype 268 N "Glutamic Acid" 7 +biotype 269 CA "Glutamic Acid" 8 +biotype 270 C "Glutamic Acid" 9 +biotype 271 HN "Glutamic Acid" 10 +biotype 272 O "Glutamic Acid" 11 +biotype 273 HA "Glutamic Acid" 12 +biotype 274 CB "Glutamic Acid" 156 +biotype 275 HB "Glutamic Acid" 157 +biotype 276 CG "Glutamic Acid" 158 +biotype 277 HG "Glutamic Acid" 159 +biotype 278 CD "Glutamic Acid" 160 +biotype 279 OE "Glutamic Acid" 161 +biotype 280 N "Glutamic Acid (COOH)" 7 +biotype 281 CA "Glutamic Acid (COOH)" 8 +biotype 282 C "Glutamic Acid (COOH)" 9 +biotype 283 HN "Glutamic Acid (COOH)" 10 +biotype 284 O "Glutamic Acid (COOH)" 11 +biotype 285 HA "Glutamic Acid (COOH)" 12 +biotype 286 CB "Glutamic Acid (COOH)" 162 +biotype 287 HB "Glutamic Acid (COOH)" 163 +biotype 288 CG "Glutamic Acid (COOH)" 164 +biotype 289 HG "Glutamic Acid (COOH)" 165 +biotype 290 CD "Glutamic Acid (COOH)" 166 +biotype 291 OE1 "Glutamic Acid (COOH)" 167 +biotype 292 OE2 "Glutamic Acid (COOH)" 168 +biotype 293 HE2 "Glutamic Acid (COOH)" 169 +biotype 294 N "Glutamine" 7 +biotype 295 CA "Glutamine" 8 +biotype 296 C "Glutamine" 9 +biotype 297 HN "Glutamine" 10 +biotype 298 O "Glutamine" 11 +biotype 299 HA "Glutamine" 12 +biotype 300 CB "Glutamine" 170 +biotype 301 HB "Glutamine" 171 +biotype 302 CG "Glutamine" 172 +biotype 303 HG "Glutamine" 173 +biotype 304 CD "Glutamine" 174 +biotype 305 OE1 "Glutamine" 175 +biotype 306 NE2 "Glutamine" 176 +biotype 307 HE2 "Glutamine" 177 +biotype 308 N "Methionine" 7 +biotype 309 CA "Methionine" 8 +biotype 310 C "Methionine" 9 +biotype 311 HN "Methionine" 10 +biotype 312 O "Methionine" 11 +biotype 313 HA "Methionine" 12 +biotype 314 CB "Methionine" 178 +biotype 315 HB "Methionine" 179 +biotype 316 CG "Methionine" 180 +biotype 317 HG "Methionine" 181 +biotype 318 SD "Methionine" 182 +biotype 319 CE "Methionine" 183 +biotype 320 HE "Methionine" 184 +biotype 321 N "Lysine" 7 +biotype 322 CA "Lysine" 8 +biotype 323 C "Lysine" 9 +biotype 324 HN "Lysine" 10 +biotype 325 O "Lysine" 11 +biotype 326 HA "Lysine" 12 +biotype 327 CB "Lysine" 185 +biotype 328 HB "Lysine" 186 +biotype 329 CG "Lysine" 187 +biotype 330 HG "Lysine" 188 +biotype 331 CD "Lysine" 189 +biotype 332 HD "Lysine" 190 +biotype 333 CE "Lysine" 191 +biotype 334 HE "Lysine" 192 +biotype 335 NZ "Lysine" 193 +biotype 336 HZ "Lysine" 194 +biotype 337 N "Lysine (NH2)" 7 +biotype 338 CA "Lysine (NH2)" 8 +biotype 339 C "Lysine (NH2)" 9 +biotype 340 HN "Lysine (NH2)" 10 +biotype 341 O "Lysine (NH2)" 11 +biotype 342 HA "Lysine (NH2)" 12 +biotype 343 CB "Lysine (NH2)" 195 +biotype 344 HB "Lysine (NH2)" 196 +biotype 345 CG "Lysine (NH2)" 197 +biotype 346 HG "Lysine (NH2)" 198 +biotype 347 CD "Lysine (NH2)" 199 +biotype 348 HD "Lysine (NH2)" 200 +biotype 349 CE "Lysine (NH2)" 201 +biotype 350 HE "Lysine (NH2)" 202 +biotype 351 NZ "Lysine (NH2)" 203 +biotype 352 HZ "Lysine (NH2)" 204 +biotype 353 N "Arginine" 7 +biotype 354 CA "Arginine" 8 +biotype 355 C "Arginine" 9 +biotype 356 HN "Arginine" 10 +biotype 357 O "Arginine" 11 +biotype 358 HA "Arginine" 12 +biotype 359 CB "Arginine" 205 +biotype 360 HB "Arginine" 206 +biotype 361 CG "Arginine" 207 +biotype 362 HG "Arginine" 208 +biotype 363 CD "Arginine" 209 +biotype 364 HD "Arginine" 210 +biotype 365 NE "Arginine" 211 +biotype 366 HE "Arginine" 212 +biotype 367 CZ "Arginine" 213 +biotype 368 NH "Arginine" 214 +biotype 369 HH "Arginine" 215 +biotype 370 N "Ornithine" 7 +biotype 371 CA "Ornithine" 8 +biotype 372 C "Ornithine" 9 +biotype 373 HN "Ornithine" 10 +biotype 374 O "Ornithine" 11 +biotype 375 HA "Ornithine" 12 +biotype 376 CB "Ornithine" 216 +biotype 377 HB "Ornithine" 217 +biotype 378 CG "Ornithine" 218 +biotype 379 HG "Ornithine" 219 +biotype 380 CD "Ornithine" 220 +biotype 381 HD "Ornithine" 221 +biotype 382 NE "Ornithine" 222 +biotype 383 HE "Ornithine" 223 +biotype 384 N "MethylAlanine (AIB)" -1 +biotype 385 CA "MethylAlanine (AIB)" -1 +biotype 386 C "MethylAlanine (AIB)" -1 +biotype 387 HN "MethylAlanine (AIB)" -1 +biotype 388 O "MethylAlanine (AIB)" -1 +biotype 389 CB "MethylAlanine (AIB)" -1 +biotype 390 HB "MethylAlanine (AIB)" -1 +biotype 391 N "Pyroglutamic Acid" -1 +biotype 392 CA "Pyroglutamic Acid" -1 +biotype 393 C "Pyroglutamic Acid" -1 +biotype 394 HN "Pyroglutamic Acid" -1 +biotype 395 O "Pyroglutamic Acid" -1 +biotype 396 HA "Pyroglutamic Acid" -1 +biotype 397 CB "Pyroglutamic Acid" -1 +biotype 398 HB "Pyroglutamic Acid" -1 +biotype 399 CG "Pyroglutamic Acid" -1 +biotype 400 HG "Pyroglutamic Acid" -1 +biotype 401 CD "Pyroglutamic Acid" -1 +biotype 402 OE "Pyroglutamic Acid" -1 +biotype 403 N "N-Terminal GLY" 234 +biotype 404 CA "N-Terminal GLY" 2 +biotype 405 C "N-Terminal GLY" 3 +biotype 406 HN "N-Terminal GLY" 235 +biotype 407 O "N-Terminal GLY" 5 +biotype 408 HA "N-Terminal GLY" 6 +biotype 409 N "N-Terminal ALA" 234 +biotype 410 CA "N-Terminal ALA" 8 +biotype 411 C "N-Terminal ALA" 9 +biotype 412 HN "N-Terminal ALA" 235 +biotype 413 O "N-Terminal ALA" 11 +biotype 414 HA "N-Terminal ALA" 12 +biotype 415 N "N-Terminal VAL" 234 +biotype 416 CA "N-Terminal VAL" 8 +biotype 417 C "N-Terminal VAL" 9 +biotype 418 HN "N-Terminal VAL" 235 +biotype 419 O "N-Terminal VAL" 11 +biotype 420 HA "N-Terminal VAL" 12 +biotype 421 N "N-Terminal LEU" 234 +biotype 422 CA "N-Terminal LEU" 8 +biotype 423 C "N-Terminal LEU" 9 +biotype 424 HN "N-Terminal LEU" 235 +biotype 425 O "N-Terminal LEU" 11 +biotype 426 HA "N-Terminal LEU" 12 +biotype 427 N "N-Terminal ILE" 234 +biotype 428 CA "N-Terminal ILE" 8 +biotype 429 C "N-Terminal ILE" 9 +biotype 430 HN "N-Terminal ILE" 235 +biotype 431 O "N-Terminal ILE" 11 +biotype 432 HA "N-Terminal ILE" 12 +biotype 433 N "N-Terminal SER" 234 +biotype 434 CA "N-Terminal SER" 33 +biotype 435 C "N-Terminal SER" 9 +biotype 436 HN "N-Terminal SER" 235 +biotype 437 O "N-Terminal SER" 11 +biotype 438 HA "N-Terminal SER" 12 +biotype 439 N "N-Terminal THR" 234 +biotype 440 CA "N-Terminal THR" 33 +biotype 441 C "N-Terminal THR" 9 +biotype 442 HN "N-Terminal THR" 235 +biotype 443 O "N-Terminal THR" 11 +biotype 444 HA "N-Terminal THR" 12 +biotype 445 N "N-Terminal CYS (SH)" 234 +biotype 446 CA "N-Terminal CYS (SH)" 44 +biotype 447 C "N-Terminal CYS (SH)" 9 +biotype 448 HN "N-Terminal CYS (SH)" 235 +biotype 449 O "N-Terminal CYS (SH)" 11 +biotype 450 HA "N-Terminal CYS (SH)" 12 +biotype 451 N "N-Terminal CYX (SS)" 234 +biotype 452 CA "N-Terminal CYX (SS)" 44 +biotype 453 C "N-Terminal CYX (SS)" 9 +biotype 454 HN "N-Terminal CYX (SS)" 235 +biotype 455 O "N-Terminal CYX (SS)" 11 +biotype 456 HA "N-Terminal CYX (SS)" 12 +biotype 457 N "N-Terminal CYD (S-)" 234 +biotype 458 CA "N-Terminal CYD (S-)" 44 +biotype 459 C "N-Terminal CYD (S-)" 9 +biotype 460 HN "N-Terminal CYD (S-)" 235 +biotype 461 O "N-Terminal CYD (S-)" 11 +biotype 462 HA "N-Terminal CYD (S-)" 12 +biotype 463 N "N-Terminal PRO" 244 +biotype 464 CA "N-Terminal PRO" 246 +biotype 465 C "N-Terminal PRO" 247 +biotype 466 HN "N-Terminal PRO" 245 +biotype 467 O "N-Terminal PRO" 248 +biotype 468 HA "N-Terminal PRO" 249 +biotype 469 CD "N-Terminal PRO" 250 +biotype 470 HD "N-Terminal PRO" 251 +biotype 471 N "N-Terminal PHE" 234 +biotype 472 CA "N-Terminal PHE" 8 +biotype 473 C "N-Terminal PHE" 9 +biotype 474 HN "N-Terminal PHE" 235 +biotype 475 O "N-Terminal PHE" 11 +biotype 476 HA "N-Terminal PHE" 12 +biotype 477 N "N-Terminal TYR" 234 +biotype 478 CA "N-Terminal TYR" 8 +biotype 479 C "N-Terminal TYR" 9 +biotype 480 HN "N-Terminal TYR" 235 +biotype 481 O "N-Terminal TYR" 11 +biotype 482 HA "N-Terminal TYR" 12 +biotype 483 N "N-Terminal TYD (O-)" 234 +biotype 484 CA "N-Terminal TYD (O-)" 8 +biotype 485 C "N-Terminal TYD (O-)" 9 +biotype 486 HN "N-Terminal TYD (O-)" 235 +biotype 487 O "N-Terminal TYD (O-)" 11 +biotype 488 HA "N-Terminal TYD (O-)" 12 +biotype 489 N "N-Terminal TRP" 234 +biotype 490 CA "N-Terminal TRP" 8 +biotype 491 C "N-Terminal TRP" 9 +biotype 492 HN "N-Terminal TRP" 235 +biotype 493 O "N-Terminal TRP" 11 +biotype 494 HA "N-Terminal TRP" 12 +biotype 495 N "N-Terminal HIS (+)" 234 +biotype 496 CA "N-Terminal HIS (+)" 8 +biotype 497 C "N-Terminal HIS (+)" 9 +biotype 498 HN "N-Terminal HIS (+)" 235 +biotype 499 O "N-Terminal HIS (+)" 11 +biotype 500 HA "N-Terminal HIS (+)" 12 +biotype 501 N "N-Terminal HIS (HD)" 234 +biotype 502 CA "N-Terminal HIS (HD)" 8 +biotype 503 C "N-Terminal HIS (HD)" 9 +biotype 504 HN "N-Terminal HIS (HD)" 235 +biotype 505 O "N-Terminal HIS (HD)" 11 +biotype 506 HA "N-Terminal HIS (HD)" 12 +biotype 507 N "N-Terminal HIS (HE)" 234 +biotype 508 CA "N-Terminal HIS (HE)" 8 +biotype 509 C "N-Terminal HIS (HE)" 9 +biotype 510 HN "N-Terminal HIS (HE)" 235 +biotype 511 O "N-Terminal HIS (HE)" 11 +biotype 512 HA "N-Terminal HIS (HE)" 12 +biotype 513 N "N-Terminal ASP" 234 +biotype 514 CA "N-Terminal ASP" 8 +biotype 515 C "N-Terminal ASP" 9 +biotype 516 HN "N-Terminal ASP" 235 +biotype 517 O "N-Terminal ASP" 11 +biotype 518 HA "N-Terminal ASP" 12 +biotype 519 N "N-Terminal ASH (COOH)" 234 +biotype 520 CA "N-Terminal ASH (COOH)" 8 +biotype 521 C "N-Terminal ASH (COOH)" 9 +biotype 522 HN "N-Terminal ASH (COOH)" 235 +biotype 523 O "N-Terminal ASH (COOH)" 11 +biotype 524 HA "N-Terminal ASH (COOH)" 12 +biotype 525 N "N-Terminal ASN" 234 +biotype 526 CA "N-Terminal ASN" 8 +biotype 527 C "N-Terminal ASN" 9 +biotype 528 HN "N-Terminal ASN" 235 +biotype 529 O "N-Terminal ASN" 11 +biotype 530 HA "N-Terminal ASN" 12 +biotype 531 N "N-Terminal GLU" 234 +biotype 532 CA "N-Terminal GLU" 8 +biotype 533 C "N-Terminal GLU" 9 +biotype 534 HN "N-Terminal GLU" 235 +biotype 535 O "N-Terminal GLU" 11 +biotype 536 HA "N-Terminal GLU" 12 +biotype 537 N "N-Terminal GLH (COOH)" 234 +biotype 538 CA "N-Terminal GLH (COOH)" 8 +biotype 539 C "N-Terminal GLH (COOH)" 9 +biotype 540 HN "N-Terminal GLH (COOH)" 235 +biotype 541 O "N-Terminal GLH (COOH)" 11 +biotype 542 HA "N-Terminal GLH (COOH)" 12 +biotype 543 N "N-Terminal GLN" 234 +biotype 544 CA "N-Terminal GLN" 8 +biotype 545 C "N-Terminal GLN" 9 +biotype 546 HN "N-Terminal GLN" 235 +biotype 547 O "N-Terminal GLN" 11 +biotype 548 HA "N-Terminal GLN" 12 +biotype 549 N "N-Terminal MET" 234 +biotype 550 CA "N-Terminal MET" 8 +biotype 551 C "N-Terminal MET" 9 +biotype 552 HN "N-Terminal MET" 235 +biotype 553 O "N-Terminal MET" 11 +biotype 554 HA "N-Terminal MET" 12 +biotype 555 N "N-Terminal LYS" 234 +biotype 556 CA "N-Terminal LYS" 8 +biotype 557 C "N-Terminal LYS" 9 +biotype 558 HN "N-Terminal LYS" 235 +biotype 559 O "N-Terminal LYS" 11 +biotype 560 HA "N-Terminal LYS" 12 +biotype 561 N "N-Terminal LYD (NH2)" 234 +biotype 562 CA "N-Terminal LYD (NH2)" 8 +biotype 563 C "N-Terminal LYD (NH2)" 9 +biotype 564 HN "N-Terminal LYD (NH2)" 235 +biotype 565 O "N-Terminal LYD (NH2)" 11 +biotype 566 HA "N-Terminal LYD (NH2)" 12 +biotype 567 N "N-Terminal ARG" 234 +biotype 568 CA "N-Terminal ARG" 8 +biotype 569 C "N-Terminal ARG" 9 +biotype 570 HN "N-Terminal ARG" 235 +biotype 571 O "N-Terminal ARG" 11 +biotype 572 HA "N-Terminal ARG" 12 +biotype 573 N "N-Terminal ORN" 234 +biotype 574 CA "N-Terminal ORN" 8 +biotype 575 C "N-Terminal ORN" 9 +biotype 576 HN "N-Terminal ORN" 235 +biotype 577 O "N-Terminal ORN" 11 +biotype 578 HA "N-Terminal ORN" 12 +biotype 579 N "N-Terminal AIB" -1 +biotype 580 CA "N-Terminal AIB" -1 +biotype 581 C "N-Terminal AIB" -1 +biotype 582 HN "N-Terminal AIB" -1 +biotype 583 O "N-Terminal AIB" -1 +biotype 584 N "C-Terminal GLY" 1 +biotype 585 CA "C-Terminal GLY" 2 +biotype 586 C "C-Terminal GLY" 238 +biotype 587 HN "C-Terminal GLY" 4 +biotype 588 OXT "C-Terminal GLY" 239 +biotype 589 HA "C-Terminal GLY" 6 +biotype 590 N "C-Terminal ALA" 7 +biotype 591 CA "C-Terminal ALA" 8 +biotype 592 C "C-Terminal ALA" 238 +biotype 593 HN "C-Terminal ALA" 10 +biotype 594 OXT "C-Terminal ALA" 239 +biotype 595 HA "C-Terminal ALA" 12 +biotype 596 N "C-Terminal VAL" 7 +biotype 597 CA "C-Terminal VAL" 8 +biotype 598 C "C-Terminal VAL" 238 +biotype 599 HN "C-Terminal VAL" 10 +biotype 600 OXT "C-Terminal VAL" 239 +biotype 601 HA "C-Terminal VAL" 12 +biotype 602 N "C-Terminal LEU" 7 +biotype 603 CA "C-Terminal LEU" 8 +biotype 604 C "C-Terminal LEU" 238 +biotype 605 HN "C-Terminal LEU" 10 +biotype 606 OXT "C-Terminal LEU" 239 +biotype 607 HA "C-Terminal LEU" 12 +biotype 608 N "C-Terminal ILE" 7 +biotype 609 CA "C-Terminal ILE" 8 +biotype 610 C "C-Terminal ILE" 238 +biotype 611 HN "C-Terminal ILE" 10 +biotype 612 OXT "C-Terminal ILE" 239 +biotype 613 HA "C-Terminal ILE" 12 +biotype 614 N "C-Terminal SER" 7 +biotype 615 CA "C-Terminal SER" 33 +biotype 616 C "C-Terminal SER" 238 +biotype 617 HN "C-Terminal SER" 10 +biotype 618 OXT "C-Terminal SER" 239 +biotype 619 HA "C-Terminal SER" 12 +biotype 620 N "C-Terminal THR" 7 +biotype 621 CA "C-Terminal THR" 33 +biotype 622 C "C-Terminal THR" 238 +biotype 623 HN "C-Terminal THR" 10 +biotype 624 OXT "C-Terminal THR" 239 +biotype 625 HA "C-Terminal THR" 12 +biotype 626 N "C-Terminal CYS (SH)" 7 +biotype 627 CA "C-Terminal CYS (SH)" 44 +biotype 628 C "C-Terminal CYS (SH)" 238 +biotype 629 HN "C-Terminal CYS (SH)" 10 +biotype 630 OXT "C-Terminal CYS (SH)" 239 +biotype 631 HA "C-Terminal CYS (SH)" 12 +biotype 632 N "C-Terminal CYX (SS)" 7 +biotype 633 CA "C-Terminal CYX (SS)" 44 +biotype 634 C "C-Terminal CYX (SS)" 238 +biotype 635 HN "C-Terminal CYX (SS)" 10 +biotype 636 OXT "C-Terminal CYX (SS)" 239 +biotype 637 HA "C-Terminal CYX (SS)" 12 +biotype 638 N "C-Terminal CYD (S-)" 7 +biotype 639 CA "C-Terminal CYD (S-)" 44 +biotype 640 C "C-Terminal CYD (S-)" 238 +biotype 641 HN "C-Terminal CYD (S-)" 10 +biotype 642 OXT "C-Terminal CYD (S-)" 239 +biotype 643 HA "C-Terminal CYD (S-)" 12 +biotype 644 N "C-Terminal PRO" 53 +biotype 645 CA "C-Terminal PRO" 54 +biotype 646 C "C-Terminal PRO" 238 +biotype 647 OXT "C-Terminal PRO" 239 +biotype 648 HA "C-Terminal PRO" 57 +biotype 649 N "C-Terminal PHE" 7 +biotype 650 CA "C-Terminal PHE" 8 +biotype 651 C "C-Terminal PHE" 238 +biotype 652 HN "C-Terminal PHE" 10 +biotype 653 OXT "C-Terminal PHE" 239 +biotype 654 HA "C-Terminal PHE" 12 +biotype 655 N "C-Terminal TYR" 7 +biotype 656 CA "C-Terminal TYR" 8 +biotype 657 C "C-Terminal TYR" 238 +biotype 658 HN "C-Terminal TYR" 10 +biotype 659 OXT "C-Terminal TYR" 239 +biotype 660 HA "C-Terminal TYR" 12 +biotype 661 N "C-Terminal TYD (O-)" 7 +biotype 662 CA "C-Terminal TYD (O-)" 8 +biotype 663 C "C-Terminal TYD (O-)" 238 +biotype 664 HN "C-Terminal TYD (O-)" 10 +biotype 665 OXT "C-Terminal TYD (O-)" 239 +biotype 666 HA "C-Terminal TYD (O-)" 12 +biotype 667 N "C-Terminal TRP" 7 +biotype 668 CA "C-Terminal TRP" 8 +biotype 669 C "C-Terminal TRP" 238 +biotype 670 HN "C-Terminal TRP" 10 +biotype 671 OXT "C-Terminal TRP" 239 +biotype 672 HA "C-Terminal TRP" 12 +biotype 673 N "C-Terminal HIS (+)" 7 +biotype 674 CA "C-Terminal HIS (+)" 8 +biotype 675 C "C-Terminal HIS (+)" 238 +biotype 676 HN "C-Terminal HIS (+)" 10 +biotype 677 OXT "C-Terminal HIS (+)" 239 +biotype 678 HA "C-Terminal HIS (+)" 12 +biotype 679 N "C-Terminal HIS (HD)" 7 +biotype 680 CA "C-Terminal HIS (HD)" 8 +biotype 681 C "C-Terminal HIS (HD)" 238 +biotype 682 HN "C-Terminal HIS (HD)" 10 +biotype 683 OXT "C-Terminal HIS (HD)" 239 +biotype 684 HA "C-Terminal HIS (HD)" 12 +biotype 685 N "C-Terminal HIS (HE)" 7 +biotype 686 CA "C-Terminal HIS (HE)" 8 +biotype 687 C "C-Terminal HIS (HE)" 238 +biotype 688 HN "C-Terminal HIS (HE)" 10 +biotype 689 OXT "C-Terminal HIS (HE)" 239 +biotype 690 HA "C-Terminal HIS (HE)" 12 +biotype 691 N "C-Terminal ASP" 7 +biotype 692 CA "C-Terminal ASP" 8 +biotype 693 C "C-Terminal ASP" 238 +biotype 694 HN "C-Terminal ASP" 10 +biotype 695 OXT "C-Terminal ASP" 239 +biotype 696 HA "C-Terminal ASP" 12 +biotype 697 N "C-Terminal ASH (COOH)" 7 +biotype 698 CA "C-Terminal ASH (COOH)" 8 +biotype 699 C "C-Terminal ASH (COOH)" 238 +biotype 700 HN "C-Terminal ASH (COOH)" 10 +biotype 701 OXT "C-Terminal ASH (COOH)" 239 +biotype 702 HA "C-Terminal ASH (COOH)" 12 +biotype 703 N "C-Terminal ASN" 7 +biotype 704 CA "C-Terminal ASN" 8 +biotype 705 C "C-Terminal ASN" 238 +biotype 706 HN "C-Terminal ASN" 10 +biotype 707 OXT "C-Terminal ASN" 239 +biotype 708 HA "C-Terminal ASN" 12 +biotype 709 N "C-Terminal GLU" 7 +biotype 710 CA "C-Terminal GLU" 8 +biotype 711 C "C-Terminal GLU" 238 +biotype 712 HN "C-Terminal GLU" 10 +biotype 713 OXT "C-Terminal GLU" 239 +biotype 714 HA "C-Terminal GLU" 12 +biotype 715 N "C-Terminal GLH (COOH)" 7 +biotype 716 CA "C-Terminal GLH (COOH)" 8 +biotype 717 C "C-Terminal GLH (COOH)" 238 +biotype 718 HN "C-Terminal GLH (COOH)" 10 +biotype 719 OXT "C-Terminal GLH (COOH)" 239 +biotype 720 HA "C-Terminal GLH (COOH)" 12 +biotype 721 N "C-Terminal GLN" 7 +biotype 722 CA "C-Terminal GLN" 8 +biotype 723 C "C-Terminal GLN" 238 +biotype 724 HN "C-Terminal GLN" 10 +biotype 725 OXT "C-Terminal GLN" 239 +biotype 726 HA "C-Terminal GLN" 12 +biotype 727 N "C-Terminal MET" 7 +biotype 728 CA "C-Terminal MET" 8 +biotype 729 C "C-Terminal MET" 238 +biotype 730 HN "C-Terminal MET" 10 +biotype 731 OXT "C-Terminal MET" 239 +biotype 732 HA "C-Terminal MET" 12 +biotype 733 N "C-Terminal LYS" 7 +biotype 734 CA "C-Terminal LYS" 8 +biotype 735 C "C-Terminal LYS" 238 +biotype 736 HN "C-Terminal LYS" 10 +biotype 737 OXT "C-Terminal LYS" 239 +biotype 738 HA "C-Terminal LYS" 12 +biotype 739 N "C-Terminal LYD (NH2)" 7 +biotype 740 CA "C-Terminal LYD (NH2)" 8 +biotype 741 C "C-Terminal LYD (NH2)" 238 +biotype 742 HN "C-Terminal LYD (NH2)" 10 +biotype 743 OXT "C-Terminal LYD (NH2)" 239 +biotype 744 HA "C-Terminal LYD (NH2)" 12 +biotype 745 N "C-Terminal ARG" 7 +biotype 746 CA "C-Terminal ARG" 8 +biotype 747 C "C-Terminal ARG" 238 +biotype 748 HN "C-Terminal ARG" 10 +biotype 749 OXT "C-Terminal ARG" 239 +biotype 750 HA "C-Terminal ARG" 12 +biotype 751 N "C-Terminal ORN" 7 +biotype 752 CA "C-Terminal ORN" 8 +biotype 753 C "C-Terminal ORN" 238 +biotype 754 HN "C-Terminal ORN" 10 +biotype 755 OXT "C-Terminal ORN" 239 +biotype 756 HA "C-Terminal ORN" 12 +biotype 757 N "C-Terminal AIB" -1 +biotype 758 CA "C-Terminal AIB" -1 +biotype 759 C "C-Terminal AIB" -1 +biotype 760 HN "C-Terminal AIB" -1 +biotype 761 OXT "C-Terminal AIB" -1 +biotype 762 N "Deprotonated N-Terminus" 236 +biotype 763 H "Deprotonated N-Terminus" 237 +biotype 764 C "Formyl N-Terminus" -1 +biotype 765 H "Formyl N-Terminus" -1 +biotype 766 O "Formyl N-Terminus" -1 +biotype 767 CH3 "Acetyl N-Terminus" 224 +biotype 768 H "Acetyl N-Terminus" 225 +biotype 769 C "Acetyl N-Terminus" 226 +biotype 770 O "Acetyl N-Terminus" 227 +biotype 771 C "Protonated C-Terminus" 240 +biotype 772 O "Protonated C-Terminus" 241 +biotype 773 OH "Protonated C-Terminus" 242 +biotype 774 HO "Protonated C-Terminus" 243 +biotype 775 N "Amide C-Terminus" 228 +biotype 776 HN "Amide C-Terminus" 229 +biotype 777 N "N-MeAmide C-Terminus" 230 +biotype 778 HN "N-MeAmide C-Terminus" 231 +biotype 779 CH3 "N-MeAmide C-Terminus" 232 +biotype 780 H "N-MeAmide C-Terminus" 233 +biotype 1001 O5* "Adenosine" 332 +biotype 1002 C5* "Adenosine" 333 +biotype 1003 H5*1 "Adenosine" 334 +biotype 1004 H5*2 "Adenosine" 335 +biotype 1005 C4* "Adenosine" 336 +biotype 1006 H4* "Adenosine" 337 +biotype 1007 O4* "Adenosine" 338 +biotype 1008 C1* "Adenosine" 339 +biotype 1009 H1* "Adenosine" 340 +biotype 1010 C3* "Adenosine" 341 +biotype 1011 H3* "Adenosine" 342 +biotype 1012 C2* "Adenosine" 343 +biotype 1013 H2* "Adenosine" 344 +biotype 1014 O2* "Adenosine" 345 +biotype 1015 HO* "Adenosine" 346 +biotype 1016 O3* "Adenosine" 347 +biotype 1017 N9 "Adenosine" 252 +biotype 1018 C4 "Adenosine" 253 +biotype 1019 C5 "Adenosine" 254 +biotype 1020 N7 "Adenosine" 255 +biotype 1021 C8 "Adenosine" 256 +biotype 1022 N3 "Adenosine" 257 +biotype 1023 C2 "Adenosine" 258 +biotype 1024 N1 "Adenosine" 259 +biotype 1025 C6 "Adenosine" 260 +biotype 1026 H2 "Adenosine" 261 +biotype 1027 N6 "Adenosine" 262 +biotype 1028 H61 "Adenosine" 263 +biotype 1029 H62 "Adenosine" 264 +biotype 1030 H8 "Adenosine" 265 +biotype 1031 O5* "Guanosine" 332 +biotype 1032 C5* "Guanosine" 333 +biotype 1033 H5*1 "Guanosine" 334 +biotype 1034 H5*2 "Guanosine" 335 +biotype 1035 C4* "Guanosine" 336 +biotype 1036 H4* "Guanosine" 337 +biotype 1037 O4* "Guanosine" 338 +biotype 1038 C1* "Guanosine" 339 +biotype 1039 H1* "Guanosine" 340 +biotype 1040 C3* "Guanosine" 341 +biotype 1041 H3* "Guanosine" 342 +biotype 1042 C2* "Guanosine" 343 +biotype 1043 H2* "Guanosine" 344 +biotype 1044 O2* "Guanosine" 345 +biotype 1045 HO* "Guanosine" 346 +biotype 1046 O3* "Guanosine" 347 +biotype 1047 N9 "Guanosine" 278 +biotype 1048 C4 "Guanosine" 279 +biotype 1049 C5 "Guanosine" 280 +biotype 1050 N7 "Guanosine" 281 +biotype 1051 C8 "Guanosine" 282 +biotype 1052 N3 "Guanosine" 283 +biotype 1053 C2 "Guanosine" 284 +biotype 1054 N1 "Guanosine" 285 +biotype 1055 C6 "Guanosine" 286 +biotype 1056 H1 "Guanosine" 287 +biotype 1057 N2 "Guanosine" 288 +biotype 1058 H21 "Guanosine" 289 +biotype 1059 H22 "Guanosine" 290 +biotype 1060 O6 "Guanosine" 291 +biotype 1061 H8 "Guanosine" 292 +biotype 1062 O5* "Cytidine" 316 +biotype 1063 C5* "Cytidine" 317 +biotype 1064 H5*1 "Cytidine" 318 +biotype 1065 H5*2 "Cytidine" 319 +biotype 1066 C4* "Cytidine" 320 +biotype 1067 H4* "Cytidine" 321 +biotype 1068 O4* "Cytidine" 322 +biotype 1069 C1* "Cytidine" 323 +biotype 1070 H1* "Cytidine" 324 +biotype 1071 C3* "Cytidine" 325 +biotype 1072 H3* "Cytidine" 326 +biotype 1073 C2* "Cytidine" 327 +biotype 1074 H2* "Cytidine" 328 +biotype 1075 O2* "Cytidine" 329 +biotype 1076 HO* "Cytidine" 330 +biotype 1077 O3* "Cytidine" 331 +biotype 1078 N1 "Cytidine" 266 +biotype 1079 C2 "Cytidine" 267 +biotype 1080 N3 "Cytidine" 268 +biotype 1081 C4 "Cytidine" 269 +biotype 1082 C5 "Cytidine" 270 +biotype 1083 C6 "Cytidine" 271 +biotype 1084 O2 "Cytidine" 272 +biotype 1085 N4 "Cytidine" 273 +biotype 1086 H41 "Cytidine" 274 +biotype 1087 H42 "Cytidine" 275 +biotype 1088 H5 "Cytidine" 276 +biotype 1089 H6 "Cytidine" 277 +biotype 1090 O5* "Uridine" 316 +biotype 1091 C5* "Uridine" 317 +biotype 1092 H5*1 "Uridine" 318 +biotype 1093 H5*2 "Uridine" 319 +biotype 1094 C4* "Uridine" 320 +biotype 1095 H4* "Uridine" 321 +biotype 1096 O4* "Uridine" 322 +biotype 1097 C1* "Uridine" 323 +biotype 1098 H1* "Uridine" 324 +biotype 1099 C3* "Uridine" 325 +biotype 1100 H3* "Uridine" 326 +biotype 1101 C2* "Uridine" 327 +biotype 1102 H2* "Uridine" 328 +biotype 1103 O2* "Uridine" 329 +biotype 1104 HO* "Uridine" 330 +biotype 1105 O3* "Uridine" 331 +biotype 1106 N1 "Uridine" 305 +biotype 1107 C2 "Uridine" 306 +biotype 1108 N3 "Uridine" 307 +biotype 1109 C4 "Uridine" 308 +biotype 1110 C5 "Uridine" 309 +biotype 1111 C6 "Uridine" 310 +biotype 1112 O2 "Uridine" 311 +biotype 1113 H3 "Uridine" 312 +biotype 1114 O4 "Uridine" 313 +biotype 1115 H5 "Uridine" 314 +biotype 1116 H6 "Uridine" 315 +biotype 1117 O5* "Deoxyadenosine" 363 +biotype 1118 C5* "Deoxyadenosine" 364 +biotype 1119 H5*1 "Deoxyadenosine" 365 +biotype 1120 H5*2 "Deoxyadenosine" 366 +biotype 1121 C4* "Deoxyadenosine" 367 +biotype 1122 H4* "Deoxyadenosine" 368 +biotype 1123 O4* "Deoxyadenosine" 369 +biotype 1124 C1* "Deoxyadenosine" 370 +biotype 1125 H1* "Deoxyadenosine" 371 +biotype 1126 C3* "Deoxyadenosine" 372 +biotype 1127 H3* "Deoxyadenosine" 373 +biotype 1128 C2* "Deoxyadenosine" 374 +biotype 1129 H2*1 "Deoxyadenosine" 375 +biotype 1130 H2*2 "Deoxyadenosine" 376 +biotype 1131 O3* "Deoxyadenosine" 377 +biotype 1132 N9 "Deoxyadenosine" 252 +biotype 1133 C4 "Deoxyadenosine" 253 +biotype 1134 C5 "Deoxyadenosine" 254 +biotype 1135 N7 "Deoxyadenosine" 255 +biotype 1136 C8 "Deoxyadenosine" 256 +biotype 1137 N3 "Deoxyadenosine" 257 +biotype 1138 C2 "Deoxyadenosine" 258 +biotype 1139 N1 "Deoxyadenosine" 259 +biotype 1140 C6 "Deoxyadenosine" 260 +biotype 1141 H2 "Deoxyadenosine" 261 +biotype 1142 N6 "Deoxyadenosine" 262 +biotype 1143 H61 "Deoxyadenosine" 263 +biotype 1144 H62 "Deoxyadenosine" 264 +biotype 1145 H8 "Deoxyadenosine" 265 +biotype 1146 O5* "Deoxyguanosine" 363 +biotype 1147 C5* "Deoxyguanosine" 364 +biotype 1148 H5*1 "Deoxyguanosine" 365 +biotype 1149 H5*2 "Deoxyguanosine" 366 +biotype 1150 C4* "Deoxyguanosine" 367 +biotype 1151 H4* "Deoxyguanosine" 368 +biotype 1152 O4* "Deoxyguanosine" 369 +biotype 1153 C1* "Deoxyguanosine" 370 +biotype 1154 H1* "Deoxyguanosine" 371 +biotype 1155 C3* "Deoxyguanosine" 372 +biotype 1156 H3* "Deoxyguanosine" 373 +biotype 1157 C2* "Deoxyguanosine" 374 +biotype 1158 H2*1 "Deoxyguanosine" 375 +biotype 1159 H2*2 "Deoxyguanosine" 376 +biotype 1160 O3* "Deoxyguanosine" 377 +biotype 1161 N9 "Deoxyguanosine" 278 +biotype 1162 C4 "Deoxyguanosine" 279 +biotype 1163 C5 "Deoxyguanosine" 280 +biotype 1164 N7 "Deoxyguanosine" 281 +biotype 1165 C8 "Deoxyguanosine" 282 +biotype 1166 N3 "Deoxyguanosine" 283 +biotype 1167 C2 "Deoxyguanosine" 284 +biotype 1168 N1 "Deoxyguanosine" 285 +biotype 1169 C6 "Deoxyguanosine" 286 +biotype 1170 H1 "Deoxyguanosine" 287 +biotype 1171 N2 "Deoxyguanosine" 288 +biotype 1172 H21 "Deoxyguanosine" 289 +biotype 1173 H22 "Deoxyguanosine" 290 +biotype 1174 O6 "Deoxyguanosine" 291 +biotype 1175 H8 "Deoxyguanosine" 292 +biotype 1176 O5* "Deoxycytidine" 348 +biotype 1177 C5* "Deoxycytidine" 349 +biotype 1178 H5*1 "Deoxycytidine" 350 +biotype 1179 H5*2 "Deoxycytidine" 351 +biotype 1180 C4* "Deoxycytidine" 352 +biotype 1181 H4* "Deoxycytidine" 353 +biotype 1182 O4* "Deoxycytidine" 354 +biotype 1183 C1* "Deoxycytidine" 355 +biotype 1184 H1* "Deoxycytidine" 356 +biotype 1185 C3* "Deoxycytidine" 357 +biotype 1186 H3* "Deoxycytidine" 358 +biotype 1187 C2* "Deoxycytidine" 359 +biotype 1188 H2*1 "Deoxycytidine" 360 +biotype 1189 H2*2 "Deoxycytidine" 361 +biotype 1190 O3* "Deoxycytidine" 362 +biotype 1191 N1 "Deoxycytidine" 266 +biotype 1192 C2 "Deoxycytidine" 267 +biotype 1193 N3 "Deoxycytidine" 268 +biotype 1194 C4 "Deoxycytidine" 269 +biotype 1195 C5 "Deoxycytidine" 270 +biotype 1196 C6 "Deoxycytidine" 271 +biotype 1197 O2 "Deoxycytidine" 272 +biotype 1198 N4 "Deoxycytidine" 273 +biotype 1199 H41 "Deoxycytidine" 274 +biotype 1200 H42 "Deoxycytidine" 275 +biotype 1201 H5 "Deoxycytidine" 276 +biotype 1202 H6 "Deoxycytidine" 277 +biotype 1203 O5* "Deoxythymidine" 348 +biotype 1204 C5* "Deoxythymidine" 349 +biotype 1205 H5*1 "Deoxythymidine" 350 +biotype 1206 H5*2 "Deoxythymidine" 351 +biotype 1207 C4* "Deoxythymidine" 352 +biotype 1208 H4* "Deoxythymidine" 353 +biotype 1209 O4* "Deoxythymidine" 354 +biotype 1210 C1* "Deoxythymidine" 355 +biotype 1211 H1* "Deoxythymidine" 356 +biotype 1212 C3* "Deoxythymidine" 357 +biotype 1213 H3* "Deoxythymidine" 358 +biotype 1214 C2* "Deoxythymidine" 359 +biotype 1215 H2*1 "Deoxythymidine" 360 +biotype 1216 H2*2 "Deoxythymidine" 361 +biotype 1217 O3* "Deoxythymidine" 362 +biotype 1218 N1 "Deoxythymidine" 293 +biotype 1219 C2 "Deoxythymidine" 294 +biotype 1220 N3 "Deoxythymidine" 295 +biotype 1221 C4 "Deoxythymidine" 296 +biotype 1222 C5 "Deoxythymidine" 297 +biotype 1223 C6 "Deoxythymidine" 298 +biotype 1224 O2 "Deoxythymidine" 299 +biotype 1225 H3 "Deoxythymidine" 300 +biotype 1226 O4 "Deoxythymidine" 301 +biotype 1227 C7 "Deoxythymidine" 302 +biotype 1228 H7 "Deoxythymidine" 303 +biotype 1229 H6 "Deoxythymidine" 304 +biotype 1230 P "Phosphodiester RNA" 378 +biotype 1231 OP "Phosphodiester RNA" 379 +biotype 1232 O5* "5'-Hydroxyl RNA" 380 +biotype 1233 H5T "5'-Hydroxyl RNA" 381 +biotype 1234 O5* "5'-Monophosphate OS RNA" 382 +biotype 1235 P "5'-Monophosphate P RNA" 383 +biotype 1236 OP "5'-Monophosphate OP RNA" 384 +biotype 1237 O3* "3'-Hydroxyl RNA" 385 +biotype 1238 H3T "3'-Hydroxyl RNA" 386 +biotype 1239 O3* "3'-Monophosphate OS RNA" 387 +biotype 1240 P "3'-Monophosphate P RNA" 388 +biotype 1241 OP "3'-Monophosphate OP RNA" 389 +biotype 1242 P "Phosphodiester DNA" 390 +biotype 1243 OP "Phosphodiester DNA" 391 +biotype 1244 O5* "5'-Hydroxyl DNA" 392 +biotype 1245 H5T "5'-Hydroxyl DNA" 393 +biotype 1246 O5* "5'-Monophosphate OS DNA" 394 +biotype 1247 P "5'-Monophosphate P DNA" 395 +biotype 1248 OP "5'-Monophosphate OP DNA" 396 +biotype 1249 O3* "3'-Hydroxyl DNA" 397 +biotype 1250 H3T "3'-Hydroxyl DNA" 398 +biotype 1251 O3* "3'-Monophosphate OS DNA" 399 +biotype 1252 P "3'-Monophosphate P DNA" 400 +biotype 1253 OP "3'-Monophosphate OP DNA" 401 +biotype 2001 O "Water" 402 +biotype 2002 H "Water" 403 +biotype 2003 LI "Lithium Ion" 404 +biotype 2004 NA "Sodium Ion" 405 +biotype 2005 K "Potassium Ion" 406 +biotype 2006 RB "Rubidium Ion" 407 +biotype 2007 CS "Cesium Ion" 408 +biotype 2008 MG "Magnesium Ion" 410 +biotype 2009 CA "Calcium Ion" 411 +biotype 2012 F "Fluoride Ion" 413 +biotype 2013 CL "Chloride Ion" 414 +biotype 2014 BR "Bromide Ion" 415 +biotype 2015 I "Iodide Ion" 416 diff --git a/examples/amoeba/amoeba_water.key b/examples/amoeba/amoeba_water.key new file mode 100644 index 0000000000..8222179c52 --- /dev/null +++ b/examples/amoeba/amoeba_water.key @@ -0,0 +1,9 @@ +parameters ./amoeba.prm + +digits 8 + +cutoff 10 +taper 8 + +polar-eps 1e-5 +usolve-diag 1.0 \ No newline at end of file diff --git a/examples/amoeba/amoeba_water.prm b/examples/amoeba/amoeba_water.prm new file mode 100644 index 0000000000..7e46d4dbb9 --- /dev/null +++ b/examples/amoeba/amoeba_water.prm @@ -0,0 +1,159 @@ + + ############################## + ## ## + ## Force Field Definition ## + ## ## + ############################## + + +forcefield AMOEBA-WATER-2003 + +bond-cubic -2.55 +bond-quartic 3.793125 +angle-cubic -0.014 +angle-quartic 0.000056 +angle-pentic -0.0000007 +angle-sextic 0.000000022 +opbendtype ALLINGER +opbend-cubic -0.014 +opbend-quartic 0.000056 +opbend-pentic -0.0000007 +opbend-sextic 0.000000022 +torsionunit 0.5 +vdwtype BUFFERED-14-7 +radiusrule CUBIC-MEAN +radiustype R-MIN +radiussize DIAMETER +epsilonrule HHG +dielectric 1.0 +polarization MUTUAL +vdw-12-scale 0.0 +vdw-13-scale 0.0 +vdw-14-scale 1.0 +vdw-15-scale 1.0 +mpole-12-scale 0.0 +mpole-13-scale 0.0 +mpole-14-scale 0.4 +#mpole-15-scale 0.8 +polar-12-scale 0.0 +polar-13-scale 0.0 +polar-14-scale 1.0 +polar-15-scale 1.0 +polar-12-intra 0.0 +polar-13-intra 0.0 +polar-14-intra 0.5 +polar-15-intra 1.0 +direct-11-scale 0.0 +direct-12-scale 1.0 +direct-13-scale 1.0 +direct-14-scale 1.0 +mutual-11-scale 1.0 +mutual-12-scale 1.0 +mutual-13-scale 1.0 +mutual-14-scale 1.0 + + + ############################# + ## ## + ## Literature References ## + ## ## + ############################# + + +P. Ren and J. W. Ponder, "A Polarizable Atomic Multipole Water Model +for Molecular Mechanics Simulation", J. Phys. Chem. B, 107, 5933-5947 +(2003) + +Y. Kong, "Multipole Electrostatic Methods for Protein Modeling with +Reaction Field Treatment", Ph.D. thesis, DBBS Program in Molecular +Biophysics, Washington University, St. Louis, August, 1997 [available +online from http://dasher.wustl.edu/ponder/] + +alternative valence parameters to match symmetric and antisymmetric +stretch frequencies by David Semrouni, Ecole Polytechnique, Paris + + + ############################# + ## ## + ## Atom Type Definitions ## + ## ## + ############################# + + +atom 1 1 O "AMOEBA Water O" 8 15.995 2 +atom 2 2 H "AMOEBA Water H" 1 1.008 1 + + + ################################ + ## ## + ## Van der Waals Parameters ## + ## ## + ################################ + + +vdw 1 3.4050 0.1100 +vdw 2 2.6550 0.0135 0.910 + + + ################################## + ## ## + ## Bond Stretching Parameters ## + ## ## + ################################## + + +#bond 1 2 529.60 0.9572 !! original AMOEBA water +bond 1 2 556.85 0.9572 + + + ################################ + ## ## + ## Angle Bending Parameters ## + ## ## + ################################ + + +#angle 2 1 2 34.05 108.50 !! original AMOEBA water +angle 2 1 2 48.70 108.50 + + + ############################### + ## ## + ## Urey-Bradley Parameters ## + ## ## + ############################### + + +#ureybrad 2 1 2 38.25 1.5537 !! original AMOEBA water +ureybrad 2 1 2 -7.60 1.5537 + + + ################################### + ## ## + ## Atomic Multipole Parameters ## + ## ## + ################################### + + +multipole 1 -2 -2 -0.51966 + 0.00000 0.00000 0.14279 + 0.37928 + 0.00000 -0.41809 + 0.00000 0.00000 0.03881 + +multipole 2 1 2 0.25983 + -0.03859 0.00000 -0.05818 + -0.03673 + 0.00000 -0.10739 + -0.00203 0.00000 0.14412 + + + ######################################## + ## ## + ## Dipole Polarizability Parameters ## + ## ## + ######################################## + + +polarize 1 0.837 0.390 2 +polarize 2 0.496 0.390 1 diff --git a/examples/amoeba/data.ubiquitin b/examples/amoeba/data.ubiquitin new file mode 100644 index 0000000000..d784798328 --- /dev/null +++ b/examples/amoeba/data.ubiquitin @@ -0,0 +1,31673 @@ +LAMMPS data file created from Tinker ubiquitin2.xyz and amoeba_ubiquitin2.prm files + +9737 atoms +6908 bonds +5094 angles +6 atom types +48 bond types +111 angle types +0 54.99 xlo xhi +0 41.91 ylo yhi +0 41.91 zlo zhi + +Masses + +1 14.003 +2 12.0 +3 15.995 +4 1.008 +5 31.972 +6 15.999 + +Atoms + +1 1 1 0 9.963103 5.604761 0.008413 +2 1 2 0 9.595854 5.616857 -1.387669 +3 1 2 0 8.190092 6.079015 -1.537478 +4 1 3 0 7.228002 5.276741 -1.343729 +5 1 4 0 9.248539 5.324856 0.671238 +6 1 4 0 10.310756 6.543175 0.309331 +7 1 4 0 10.709289 4.952168 0.170763 +8 1 4 0 10.342605 6.385672 -1.876827 +9 1 2 0 9.777424 4.134312 -1.928716 +10 1 2 0 9.485635 3.817581 -3.412559 +11 1 5 0 10.117567 2.116666 -3.905314 +12 1 2 0 9.214556 1.102048 -2.698793 +13 1 4 0 8.995937 3.481218 -1.313618 +14 1 4 0 10.813555 3.756529 -1.729292 +15 1 4 0 10.074410 4.479912 -4.109344 +16 1 4 0 8.425285 3.844015 -3.623677 +17 1 4 0 9.476005 1.466410 -1.683717 +18 1 4 0 9.531462 0.065851 -2.728696 +19 1 4 0 8.157703 1.221346 -2.837348 +20 1 1 0 8.075651 7.407997 -1.589694 +21 1 2 0 6.846787 8.085212 -1.711474 +22 1 2 0 6.189365 7.484141 -3.005186 +23 1 3 0 6.734597 7.675309 -4.068223 +24 1 4 0 8.951370 7.929371 -1.808185 +25 1 4 0 6.170991 7.786742 -0.821099 +26 1 2 0 7.045430 9.684350 -1.731240 +27 1 2 0 5.783147 10.543682 -1.755861 +28 1 2 0 4.878227 10.489051 -3.011941 +29 1 3 0 5.100354 11.293553 -3.954911 +30 1 1 0 3.787647 9.697542 -2.965312 +31 1 4 0 7.774130 9.919050 -2.476360 +32 1 4 0 7.651586 10.027873 -0.831299 +33 1 4 0 6.211664 11.592747 -1.874653 +34 1 4 0 5.241990 10.447103 -0.794638 +35 1 4 0 3.649816 9.134508 -2.112027 +36 1 4 0 3.185263 9.534971 -3.811678 +37 1 1 0 5.036494 6.768214 -2.882880 +38 1 2 0 4.174197 6.305367 -3.990075 +39 1 2 0 2.728098 6.643573 -3.679890 +40 1 3 0 2.485580 7.278505 -2.662964 +41 1 4 0 4.569007 6.922928 -2.037115 +42 1 4 0 4.411152 6.930990 -4.873795 +43 1 2 0 4.308955 4.772244 -4.223706 +44 1 2 0 3.611944 3.837131 -3.115456 +45 1 2 0 5.819814 4.327532 -4.394409 +46 1 2 0 3.741844 2.375632 -3.462760 +47 1 4 0 3.791883 4.511448 -5.208449 +48 1 4 0 2.547744 4.084411 -3.073934 +49 1 4 0 4.014866 4.138283 -2.115089 +50 1 4 0 6.389594 4.495961 -3.449963 +51 1 4 0 6.367709 4.976173 -5.128547 +52 1 4 0 5.908880 3.195479 -4.756566 +53 1 4 0 3.393827 2.185310 -4.536109 +54 1 4 0 3.102312 1.694874 -2.887955 +55 1 4 0 4.760146 2.000072 -3.426085 +56 1 1 0 1.684147 6.367185 -4.575190 +57 1 2 0 0.304736 6.655628 -4.231748 +58 1 2 0 -0.626185 5.414986 -4.519968 +59 1 3 0 -0.188430 4.481000 -5.239972 +60 1 4 0 1.811341 5.682101 -5.345446 +61 1 4 0 0.263980 6.686032 -3.118862 +62 1 2 0 -0.297187 7.876289 -4.967331 +63 1 2 0 0.656467 9.081574 -5.199077 +64 1 2 0 1.564880 9.231158 -6.344247 +65 1 2 0 0.518242 10.180719 -4.311011 +66 1 2 0 2.254905 10.428397 -6.564398 +67 1 2 0 1.266077 11.295338 -4.552651 +68 1 2 0 2.142006 11.455092 -5.583064 +69 1 4 0 -1.140556 8.280905 -4.296048 +70 1 4 0 -0.810414 7.566064 -5.884866 +71 1 4 0 1.670266 8.406033 -7.077975 +72 1 4 0 -0.165699 10.178758 -3.490791 +73 1 4 0 2.904650 10.539850 -7.451626 +74 1 4 0 1.204400 12.095766 -3.710976 +75 1 4 0 2.760015 12.463610 -5.750178 +76 1 1 0 -1.919463 5.547799 -4.105657 +77 1 2 0 -3.045010 4.631011 -4.380927 +78 1 2 0 -4.206191 5.442932 -4.923986 +79 1 3 0 -4.727895 6.299647 -4.174539 +80 1 4 0 -2.189033 6.454364 -3.576690 +81 1 4 0 -2.684685 3.831124 -5.207150 +82 1 2 0 -3.444418 3.799031 -3.130661 +83 1 2 0 -4.638073 2.796605 -3.426800 +84 1 2 0 -2.172636 3.025555 -2.692910 +85 1 4 0 -3.669812 4.518348 -2.290701 +86 1 4 0 -4.428840 2.137544 -4.376863 +87 1 4 0 -5.534299 3.436652 -3.543248 +88 1 4 0 -4.789185 2.176325 -2.494354 +89 1 4 0 -1.667617 3.522055 -1.846039 +90 1 4 0 -1.416445 2.861139 -3.471806 +91 1 4 0 -2.413054 1.986644 -2.328475 +92 1 1 0 -4.550673 5.196731 -6.274871 +93 1 2 0 -5.820881 5.714130 -6.792896 +94 1 2 0 -6.901797 4.657281 -6.559257 +95 1 3 0 -6.707326 3.538748 -6.976520 +96 1 4 0 -4.247417 4.330282 -6.731623 +97 1 4 0 -6.018895 6.628095 -6.157881 +98 1 2 0 -5.786797 6.030910 -8.386430 +99 1 2 0 -7.031253 6.879587 -8.916479 +100 1 2 0 -6.946629 7.328107 -10.409836 +101 1 2 0 -6.782582 6.224048 -11.537592 +102 1 1 0 -6.791739 6.775547 -12.918869 +103 1 4 0 -5.650656 5.119864 -8.896094 +104 1 4 0 -4.894535 6.632893 -8.720825 +105 1 4 0 -7.188700 7.743879 -8.218707 +106 1 4 0 -7.899583 6.225721 -8.760371 +107 1 4 0 -5.985957 7.986594 -10.510771 +108 1 4 0 -7.792216 7.961266 -10.639952 +109 1 4 0 -7.448325 5.332480 -11.448147 +110 1 4 0 -5.800269 5.666745 -11.336805 +111 1 4 0 -5.991776 7.279636 -13.178670 +112 1 4 0 -7.621495 7.404931 -13.058222 +113 1 4 0 -6.983504 6.085979 -13.693073 +114 1 1 0 -8.069363 5.037776 -5.939754 +115 1 2 0 -9.334342 4.259320 -5.870215 +116 1 2 0 -10.106400 4.390027 -7.235984 +117 1 3 0 -9.678872 5.138872 -8.064541 +118 1 4 0 -8.065341 5.988423 -5.484094 +119 1 4 0 -9.057846 3.167719 -5.835950 +120 1 2 0 -10.266512 4.660993 -4.660344 +121 1 3 0 -10.534149 6.114601 -4.706758 +122 1 2 0 -9.745157 4.269631 -3.191928 +123 1 4 0 -11.263017 4.131676 -4.781723 +124 1 4 0 -9.713871 6.599029 -4.391676 +125 1 4 0 -9.116723 4.972749 -2.508566 +126 1 4 0 -9.168034 3.361328 -3.330127 +127 1 4 0 -10.522836 3.973872 -2.499829 +128 1 1 0 -11.233860 3.687218 -7.306137 +129 1 2 0 -12.200193 3.653311 -8.374575 +130 1 2 0 -13.220650 4.788154 -8.169599 +131 1 3 0 -13.737841 5.372844 -9.165473 +132 1 4 0 -11.460538 2.988105 -6.540266 +133 1 4 0 -11.637688 3.949136 -9.406377 +134 1 2 0 -12.914543 2.186268 -8.423705 +135 1 2 0 -12.050888 0.859767 -8.189045 +136 1 2 0 -12.754212 -0.443223 -8.481524 +137 1 2 0 -10.761720 0.854864 -8.962914 +138 1 4 0 -13.378342 2.203311 -9.441391 +139 1 4 0 -13.731396 2.273518 -7.697910 +140 1 4 0 -11.784384 0.837730 -7.097584 +141 1 4 0 -12.178199 -1.386252 -8.511713 +142 1 4 0 -13.030296 -0.361584 -9.541647 +143 1 4 0 -13.665537 -0.574300 -7.888432 +144 1 4 0 -10.907312 0.853311 -10.020395 +145 1 4 0 -10.166450 -0.087962 -8.625340 +146 1 4 0 -10.131655 1.808766 -8.717686 +147 1 1 0 -13.463568 5.196109 -6.936262 +148 1 2 0 -14.321525 6.337206 -6.640073 +149 1 2 0 -13.602436 7.749411 -6.813046 +150 1 3 0 -14.285287 8.753093 -7.068264 +151 1 4 0 -13.224563 4.686522 -6.108713 +152 1 4 0 -15.116925 6.447123 -7.471724 +153 1 2 0 -15.130805 6.126006 -5.300665 +154 1 3 0 -14.245708 5.884444 -4.246742 +155 1 2 0 -16.085304 4.854769 -5.370470 +156 1 4 0 -15.668029 7.073411 -5.139360 +157 1 4 0 -13.863528 6.745981 -4.031876 +158 1 4 0 -16.931480 4.985645 -6.114646 +159 1 4 0 -16.633409 4.776539 -4.392875 +160 1 4 0 -15.447009 3.996959 -5.527187 +161 1 1 0 -12.255780 7.804163 -6.773987 +162 1 2 0 -11.475822 9.029360 -6.961862 +163 1 2 0 -10.482668 9.429993 -5.875126 +164 1 3 0 -9.615012 10.212498 -6.150085 +165 1 4 0 -11.791631 6.946169 -6.476230 +166 1 4 0 -10.849439 8.869550 -7.825758 +167 1 4 0 -12.070294 9.912283 -7.089554 +168 1 1 0 -10.710240 8.937450 -4.551265 +169 1 2 0 -9.795182 9.275190 -3.486218 +170 1 2 0 -8.432503 8.733444 -3.903900 +171 1 3 0 -8.256860 7.497941 -4.141932 +172 1 4 0 -11.613017 8.458729 -4.378865 +173 1 4 0 -9.758201 10.415786 -3.586213 +174 1 2 0 -10.207682 8.847560 -2.068515 +175 1 2 0 -9.468868 9.640494 -0.969458 +176 1 2 0 -9.960726 11.106750 -0.880514 +177 1 2 0 -8.996147 11.882980 0.056845 +178 1 1 0 -9.422979 13.246330 0.389189 +179 1 4 0 -10.025076 7.711214 -1.993654 +180 1 4 0 -11.260829 8.969143 -1.909413 +181 1 4 0 -8.357381 9.561485 -1.037070 +182 1 4 0 -9.831062 9.156523 0.052119 +183 1 4 0 -10.951565 11.152527 -0.421834 +184 1 4 0 -10.025528 11.645570 -1.861235 +185 1 4 0 -7.996392 12.007902 -0.493686 +186 1 4 0 -8.903714 11.241749 1.019391 +187 1 4 0 -9.372439 13.931515 -0.356496 +188 1 4 0 -8.869279 13.642636 1.216690 +189 1 4 0 -10.417962 13.346471 0.725918 +190 1 1 0 -7.417712 9.626751 -3.887457 +191 1 2 0 -6.048686 9.319758 -4.265281 +192 1 2 0 -5.195256 9.655954 -3.012996 +193 1 3 0 -5.383682 10.790154 -2.469855 +194 1 4 0 -7.536192 10.638944 -3.603417 +195 1 4 0 -5.899497 8.237555 -4.489940 +196 1 2 0 -5.632346 10.139153 -5.558621 +197 1 3 0 -6.651850 9.845307 -6.610520 +198 1 2 0 -4.307909 9.733791 -6.252541 +199 1 4 0 -5.546957 11.240303 -5.391676 +200 1 4 0 -7.479446 10.239776 -6.352124 +201 1 4 0 -4.057722 10.346459 -7.141293 +202 1 4 0 -4.216816 8.651918 -6.414903 +203 1 4 0 -3.513698 9.947681 -5.542599 +204 1 1 0 -4.487761 8.698281 -2.479508 +205 1 2 0 -3.941682 8.719222 -1.101838 +206 1 2 0 -2.471661 8.338585 -1.186861 +207 1 3 0 -2.098577 7.337481 -1.795680 +208 1 4 0 -4.371107 7.734334 -2.775858 +209 1 4 0 -3.985516 9.750968 -0.737465 +210 1 2 0 -4.697768 7.852820 -0.064484 +211 1 2 0 -4.708913 6.295035 -0.438982 +212 1 2 0 -6.123205 8.316839 0.212195 +213 1 2 0 -5.620903 5.382941 0.512646 +214 1 4 0 -4.057362 7.911400 0.860642 +215 1 4 0 -3.677285 5.838816 -0.381317 +216 1 4 0 -5.097879 6.136516 -1.456773 +217 1 4 0 -6.958332 8.061232 -0.486042 +218 1 4 0 -6.120750 9.492014 0.254246 +219 1 4 0 -6.463653 8.052122 1.235972 +220 1 4 0 -6.708420 5.577546 0.309314 +221 1 4 0 -5.353714 5.729677 1.560568 +222 1 4 0 -5.449967 4.323238 0.397743 +223 1 1 0 -1.597496 9.147378 -0.364603 +224 1 2 0 -0.135695 9.298656 -0.268971 +225 1 2 0 0.407838 8.259131 0.762984 +226 1 3 0 -0.125678 8.256398 1.864934 +227 1 4 0 -2.061490 9.698188 0.341812 +228 1 4 0 0.291486 9.062300 -1.222284 +229 1 2 0 0.359683 10.712136 0.203065 +230 1 3 0 -0.513535 11.802509 -0.157986 +231 1 2 0 1.661404 11.100111 -0.496546 +232 1 4 0 0.487415 10.613723 1.289529 +233 1 4 0 -0.894682 12.193680 0.613553 +234 1 4 0 1.924560 12.095482 -0.170163 +235 1 4 0 1.527624 11.126022 -1.612055 +236 1 4 0 2.524096 10.406872 -0.273554 +237 1 1 0 1.458638 7.533911 0.367476 +238 1 2 0 2.250809 6.653110 1.155065 +239 1 2 0 3.767103 6.967571 0.917085 +240 1 3 0 4.150469 7.414883 -0.134304 +241 1 4 0 1.800100 7.626011 -0.603649 +242 1 4 0 1.984132 6.848652 2.199761 +243 1 2 0 1.985932 5.208560 0.673411 +244 1 2 0 0.499001 4.775460 0.950638 +245 1 2 0 0.302449 3.382258 0.307039 +246 1 2 0 0.318833 4.590905 2.467625 +247 1 4 0 2.620352 4.479840 1.153057 +248 1 4 0 2.170192 5.140748 -0.421262 +249 1 4 0 -0.141837 5.460611 0.448133 +250 1 4 0 -0.765868 3.158508 0.337643 +251 1 4 0 0.881511 2.586559 0.876485 +252 1 4 0 0.635114 3.382961 -0.727832 +253 1 4 0 0.991181 3.809378 2.860913 +254 1 4 0 -0.810422 4.305406 2.724253 +255 1 4 0 0.495432 5.527245 3.085307 +256 1 1 0 4.493868 6.668739 2.051013 +257 1 2 0 5.977452 6.826187 2.081574 +258 1 2 0 6.574479 5.473810 2.542943 +259 1 3 0 7.539223 5.437653 3.331859 +260 1 4 0 4.101906 6.335458 2.916399 +261 1 4 0 6.354091 6.853748 1.027532 +262 1 2 0 6.470006 8.005228 2.962480 +263 1 2 0 6.523156 9.385148 2.265263 +264 1 2 0 6.660389 10.531119 3.176475 +265 1 3 0 7.818717 10.946737 3.494784 +266 1 3 0 5.641727 11.057335 3.676704 +267 1 4 0 7.426538 7.872313 3.417016 +268 1 4 0 5.818378 7.862045 3.841666 +269 1 4 0 5.562369 9.490953 1.596644 +270 1 4 0 7.296811 9.382149 1.478494 +271 1 1 0 6.080956 4.317668 2.172588 +272 1 2 0 6.395184 2.914756 2.360428 +273 1 2 0 7.756330 2.626277 1.796235 +274 1 3 0 8.336336 3.369371 0.946953 +275 1 4 0 5.286582 4.431259 1.580017 +276 1 4 0 6.544551 2.775770 3.450173 +277 1 2 0 5.254270 2.029334 1.828047 +278 1 2 0 3.855516 2.115298 2.663831 +279 1 2 0 4.878513 2.275077 0.297641 +280 1 4 0 5.659978 0.937168 1.997214 +281 1 4 0 3.988977 1.632132 3.721066 +282 1 4 0 3.154094 1.488836 2.202125 +283 1 4 0 3.518024 3.208135 2.707458 +284 1 4 0 4.391723 3.244259 0.119355 +285 1 4 0 4.197460 1.515591 -0.214541 +286 1 4 0 5.820024 2.281294 -0.232189 +287 1 1 0 8.439412 1.532076 2.306730 +288 1 2 0 9.766718 1.104522 1.810124 +289 1 2 0 9.609640 -0.146333 0.921245 +290 1 3 0 8.595667 -0.823014 1.060066 +291 1 4 0 7.906057 0.817610 2.769235 +292 1 4 0 10.402589 1.878772 1.340853 +293 1 2 0 10.623245 0.647963 3.024596 +294 1 2 0 11.099332 1.681203 4.040791 +295 1 2 0 12.471923 2.276164 3.591284 +296 1 3 0 13.467460 1.635754 4.022756 +297 1 3 0 12.447093 3.241865 2.732975 +298 1 4 0 11.464087 0.045385 2.632771 +299 1 4 0 10.035308 -0.165388 3.606999 +300 1 4 0 11.283249 1.117646 5.042705 +301 1 4 0 10.341030 2.493195 4.310498 +302 1 1 0 10.649425 -0.442448 0.039711 +303 1 2 0 10.721650 -1.691625 -0.719097 +304 1 2 0 10.688929 -3.019270 0.171469 +305 1 3 0 10.136780 -4.017164 -0.258017 +306 1 4 0 9.824725 -1.703322 -1.331408 +307 1 2 0 12.047830 -1.730137 -1.583772 +308 1 2 0 12.438841 -0.254934 -1.430560 +309 1 2 0 11.880473 0.342410 -0.130781 +310 1 4 0 11.910217 -2.011767 -2.680814 +311 1 4 0 12.740874 -2.453727 -1.101295 +312 1 4 0 12.084519 0.391154 -2.320456 +313 1 4 0 13.550172 -0.165266 -1.345695 +314 1 4 0 11.730541 1.403440 -0.268593 +315 1 4 0 12.568702 0.262680 0.684216 +316 1 1 0 11.185418 -2.821488 1.401909 +317 1 2 0 11.478487 -3.819995 2.417066 +318 1 2 0 10.240507 -4.133695 3.340195 +319 1 3 0 10.437807 -4.944657 4.272068 +320 1 4 0 11.675553 -1.939666 1.629182 +321 1 4 0 11.715305 -4.763029 1.892686 +322 1 2 0 12.726302 -3.441835 3.258589 +323 1 3 0 12.588509 -2.169159 3.871288 +324 1 4 0 13.594515 -3.465914 2.619460 +325 1 4 0 12.919669 -4.225010 4.041833 +326 1 4 0 11.928461 -2.056942 4.572136 +327 1 1 0 8.989610 -3.538327 3.147788 +328 1 2 0 7.780090 -3.809839 3.903153 +329 1 2 0 6.830692 -4.723128 3.182411 +330 1 3 0 6.843975 -4.931536 1.971249 +331 1 4 0 8.790490 -2.959432 2.207143 +332 1 4 0 8.112743 -4.402734 4.754275 +333 1 2 0 7.007696 -2.493713 4.325713 +334 1 2 0 7.757815 -1.793205 5.421557 +335 1 3 0 8.301432 -0.683792 5.213313 +336 1 3 0 8.105449 -2.430264 6.467845 +337 1 4 0 6.015719 -2.736995 4.787540 +338 1 4 0 6.870322 -1.705199 3.554568 +339 1 1 0 5.911537 -5.420074 3.889645 +340 1 2 0 4.985368 -6.339027 3.207488 +341 1 2 0 3.791981 -5.460118 2.675447 +342 1 3 0 3.602436 -4.262217 3.058351 +343 1 4 0 5.945002 -5.355465 4.936544 +344 1 4 0 5.522096 -6.871961 2.401608 +345 1 2 0 4.403843 -7.437211 4.151447 +346 1 3 0 3.984983 -6.837474 5.417872 +347 1 2 0 5.484751 -8.435266 4.460478 +348 1 4 0 3.543374 -7.871125 3.610585 +349 1 4 0 3.626750 -7.635311 5.866975 +350 1 4 0 5.852794 -8.923165 3.576288 +351 1 4 0 5.092476 -9.235700 5.230406 +352 1 4 0 6.347457 -8.009387 5.033245 +353 1 1 0 3.001520 -6.091562 1.873663 +354 1 2 0 1.770212 -5.563203 1.356920 +355 1 2 0 0.721356 -5.331197 2.570590 +356 1 3 0 -0.022158 -4.354859 2.639919 +357 1 4 0 3.312873 -6.951353 1.400664 +358 1 4 0 2.050592 -4.577254 0.922928 +359 1 2 0 1.071972 -6.339450 0.158527 +360 1 2 0 1.737761 -5.960287 -1.242592 +361 1 2 0 -0.457848 -6.189077 0.133627 +362 1 2 0 3.239275 -5.961276 -1.280042 +363 1 4 0 1.324741 -7.458613 0.269568 +364 1 4 0 1.479259 -4.859796 -1.271486 +365 1 4 0 1.361220 -6.531125 -2.132946 +366 1 4 0 -0.903041 -6.854230 -0.657366 +367 1 4 0 -0.782418 -5.132849 -0.071473 +368 1 4 0 -0.922422 -6.573767 1.109124 +369 1 4 0 3.570026 -6.965706 -1.066579 +370 1 4 0 3.783014 -5.330759 -0.595789 +371 1 4 0 3.656696 -5.782972 -2.272787 +372 1 1 0 0.712989 -6.304521 3.584311 +373 1 2 0 0.052790 -6.261661 4.839148 +374 1 2 0 0.191347 -4.895606 5.488007 +375 1 3 0 -0.836031 -4.209177 5.761481 +376 1 4 0 1.234822 -7.176952 3.358561 +377 1 4 0 -1.022887 -6.329021 4.691721 +378 1 2 0 0.463881 -7.420468 5.813551 +379 1 2 0 -0.181732 -7.570702 7.165576 +380 1 2 0 0.007120 -6.414258 8.102713 +381 1 3 0 -0.893307 -5.557057 8.345423 +382 1 3 0 1.071916 -6.451342 8.739901 +383 1 4 0 1.565739 -7.379644 5.945185 +384 1 4 0 0.280894 -8.335875 5.233490 +385 1 4 0 0.223173 -8.515314 7.648734 +386 1 4 0 -1.278836 -7.754581 6.974807 +387 1 1 0 1.506487 -4.494779 5.655260 +388 1 2 0 2.024384 -3.272083 6.150972 +389 1 2 0 1.585880 -2.044887 5.407014 +390 1 3 0 1.072089 -1.054656 5.937784 +391 1 4 0 2.247022 -5.169015 5.381363 +392 1 4 0 1.726295 -3.077017 7.202284 +393 1 2 0 3.519486 -3.297907 6.249706 +394 1 2 0 4.110165 -2.209620 7.106417 +395 1 3 0 4.558866 -1.206675 6.574355 +396 1 1 0 3.975447 -2.353795 8.429417 +397 1 4 0 3.926527 -3.312701 5.199577 +398 1 4 0 3.906987 -4.290859 6.729019 +399 1 4 0 3.351621 -3.100412 8.835262 +400 1 4 0 4.250233 -1.572327 9.095945 +401 1 1 0 1.646215 -2.106555 3.995169 +402 1 2 0 0.960547 -1.056203 3.144271 +403 1 2 0 -0.585323 -0.906494 3.471384 +404 1 3 0 -1.001272 0.221409 3.639638 +405 1 4 0 2.076586 -2.917444 3.633085 +406 1 4 0 1.398083 -0.037330 3.348893 +407 1 2 0 1.148406 -1.421290 1.565953 +408 1 2 0 0.469253 -0.291141 0.677094 +409 1 2 0 2.652804 -1.432319 1.256255 +410 1 4 0 0.776571 -2.470203 1.403081 +411 1 4 0 -0.604778 -0.059927 0.825468 +412 1 4 0 0.696071 -0.403531 -0.364402 +413 1 4 0 0.904174 0.691668 0.985463 +414 1 4 0 2.642691 -1.597766 0.131660 +415 1 4 0 3.137894 -2.381059 1.586216 +416 1 4 0 3.298051 -0.632131 1.598249 +417 1 1 0 -1.305966 -1.988607 3.652565 +418 1 2 0 -2.689415 -1.960736 4.065894 +419 1 2 0 -2.947986 -1.384388 5.464246 +420 1 3 0 -3.956927 -0.687209 5.701440 +421 1 4 0 -0.971106 -2.849328 3.302467 +422 1 4 0 -3.296900 -1.262385 3.382761 +423 1 2 0 -3.427836 -3.412377 3.961933 +424 1 2 0 -3.574171 -3.928612 2.505721 +425 1 2 0 -3.982306 -5.479470 2.370643 +426 1 2 0 -4.137753 -5.916145 0.907307 +427 1 1 0 -4.842456 -7.207476 0.671588 +428 1 4 0 -4.389394 -3.425752 4.550163 +429 1 4 0 -2.806920 -4.163717 4.552623 +430 1 4 0 -2.578225 -3.744348 2.022778 +431 1 4 0 -4.131610 -3.317335 1.794895 +432 1 4 0 -4.944670 -5.685367 2.884988 +433 1 4 0 -3.219699 -6.072549 2.922384 +434 1 4 0 -3.220948 -5.866340 0.240386 +435 1 4 0 -4.886137 -5.224022 0.371600 +436 1 4 0 -4.398637 -8.010724 1.108282 +437 1 4 0 -4.689919 -7.536305 -0.283243 +438 1 4 0 -5.789366 -7.298894 0.961468 +439 1 1 0 -1.966539 -1.653932 6.352370 +440 1 2 0 -1.877059 -1.184384 7.700740 +441 1 2 0 -1.810243 0.352689 7.772527 +442 1 3 0 -2.478130 1.012858 8.630055 +443 1 4 0 -1.296883 -2.342673 6.065841 +444 1 4 0 -2.903503 -1.425619 8.306499 +445 1 2 0 -0.719870 -1.906634 8.460693 +446 1 4 0 -0.392867 -1.394748 9.399750 +447 1 4 0 0.201561 -1.700787 7.931161 +448 1 4 0 -0.824494 -3.016135 8.415257 +449 1 1 0 -1.014819 0.884949 6.873831 +450 1 2 0 -0.928004 2.359933 6.752150 +451 1 2 0 -2.242871 3.020975 6.141860 +452 1 3 0 -2.667293 4.165871 6.497798 +453 1 4 0 -0.255487 0.266534 6.475305 +454 1 4 0 -0.709751 2.767594 7.790539 +455 1 2 0 0.185451 2.818592 5.731872 +456 1 2 0 1.718082 2.368933 6.157097 +457 1 2 0 1.976397 2.630036 7.634372 +458 1 2 0 3.272626 1.811866 8.042755 +459 1 1 0 3.783277 2.119562 9.341763 +460 1 4 0 0.173809 4.017727 5.824418 +461 1 4 0 -0.110843 2.644975 4.655738 +462 1 4 0 2.436177 2.906087 5.459782 +463 1 4 0 1.767963 1.228903 6.013437 +464 1 4 0 1.214734 2.413689 8.372810 +465 1 4 0 2.023085 3.725792 7.759055 +466 1 4 0 4.113891 1.884123 7.336520 +467 1 4 0 2.915132 0.727469 8.065927 +468 1 4 0 3.879659 1.332383 9.938486 +469 1 4 0 3.292027 2.768104 9.893226 +470 1 4 0 4.657654 2.620898 9.415395 +471 1 1 0 -2.951323 2.325118 5.282730 +472 1 2 0 -4.325905 2.722744 4.841568 +473 1 2 0 -5.448579 2.576087 5.910067 +474 1 3 0 -6.209518 3.521045 6.095847 +475 1 4 0 -2.521898 1.551084 4.791650 +476 1 4 0 -4.313051 3.829830 4.708638 +477 1 2 0 -4.631289 2.056947 3.491556 +478 1 2 0 -3.597982 2.356462 2.341899 +479 1 2 0 -6.057287 2.415036 2.978562 +480 1 2 0 -3.795503 1.412901 1.156511 +481 1 4 0 -4.671054 0.937191 3.752299 +482 1 4 0 -2.607674 2.121882 2.680974 +483 1 4 0 -3.588639 3.467984 2.067654 +484 1 4 0 -6.778277 2.127584 3.784506 +485 1 4 0 -6.408690 1.672558 2.286363 +486 1 4 0 -6.257305 3.445522 2.543283 +487 1 4 0 -2.827681 1.370598 0.452926 +488 1 4 0 -4.701905 1.709692 0.600596 +489 1 4 0 -3.968868 0.353877 1.535108 +490 1 1 0 -5.427736 1.517434 6.772139 +491 1 2 0 -6.281638 1.417159 7.917235 +492 1 2 0 -6.135061 2.619316 8.825463 +493 1 3 0 -7.083993 3.050483 9.468967 +494 1 4 0 -4.778187 0.710522 6.592937 +495 1 4 0 -7.347518 1.392997 7.523591 +496 1 2 0 -5.911289 0.089334 8.730160 +497 1 2 0 -6.704804 -0.165892 10.024245 +498 1 2 0 -8.207420 0.060746 9.966819 +499 1 3 0 -8.766731 0.511631 10.987813 +500 1 1 0 -8.851167 -0.577098 8.977765 +501 1 4 0 -4.871800 0.035639 8.932959 +502 1 4 0 -6.099650 -0.797867 8.002499 +503 1 4 0 -6.379603 0.602172 10.795373 +504 1 4 0 -6.514059 -1.228415 10.339368 +505 1 4 0 -8.316985 -1.014678 8.258816 +506 1 4 0 -9.833090 -0.545963 8.919578 +507 1 1 0 -4.878643 3.139322 9.062914 +508 1 2 0 -4.649566 4.328949 9.987955 +509 1 2 0 -4.957775 5.668926 9.413617 +510 1 3 0 -5.630236 6.445624 10.106188 +511 1 4 0 -4.081549 2.846329 8.507102 +512 1 4 0 -5.406537 4.281488 10.784832 +513 1 2 0 -3.243945 4.227889 10.546816 +514 1 2 0 -3.087728 5.171882 11.728346 +515 1 3 0 -4.053576 5.190045 12.600221 +516 1 3 0 -2.058101 5.835943 11.978474 +517 1 4 0 -2.562382 4.521403 9.724738 +518 1 4 0 -2.932032 3.215635 10.964683 +519 1 1 0 -4.878039 5.785317 8.031390 +520 1 2 0 -5.310084 7.089332 7.406389 +521 1 2 0 -6.749125 7.172087 6.971101 +522 1 3 0 -7.405628 8.229614 7.089684 +523 1 4 0 -4.283642 5.091117 7.531729 +524 1 4 0 -5.274077 7.841191 8.198368 +525 1 2 0 -4.287673 7.649544 6.440392 +526 1 2 0 -4.264316 6.824230 5.084233 +527 1 2 0 -3.348184 7.282872 3.940214 +528 1 2 0 -1.862959 6.984827 4.246876 +529 1 1 0 -1.232990 7.951755 5.175746 +530 1 4 0 -3.353989 7.682751 6.978380 +531 1 4 0 -4.577117 8.665353 6.188031 +532 1 4 0 -5.271336 7.010431 4.645228 +533 1 4 0 -4.183939 5.756196 5.214904 +534 1 4 0 -3.478219 8.414723 3.726542 +535 1 4 0 -3.567163 6.665420 3.125679 +536 1 4 0 -1.380469 7.033451 3.200397 +537 1 4 0 -1.658625 5.960828 4.579387 +538 1 4 0 -1.681026 8.865239 5.169898 +539 1 4 0 -0.322832 8.170574 4.811931 +540 1 4 0 -1.120976 7.690090 6.115363 +541 1 1 0 -7.260673 6.129896 6.365283 +542 1 2 0 -8.574938 6.119982 5.731267 +543 1 2 0 -9.544300 5.242356 6.500946 +544 1 3 0 -10.776630 5.341657 6.228564 +545 1 4 0 -6.694313 5.297054 6.084394 +546 1 4 0 -8.965369 7.148290 5.836761 +547 1 2 0 -8.593435 5.700600 4.232465 +548 1 2 0 -8.142917 6.797216 3.313691 +549 1 2 0 -8.922098 8.128550 3.290754 +550 1 3 0 -10.019708 8.282415 2.683597 +551 1 3 0 -8.418377 9.080422 3.962396 +552 1 4 0 -9.637470 5.370747 3.983240 +553 1 4 0 -7.841735 4.791994 4.106244 +554 1 4 0 -7.988334 6.410373 2.240226 +555 1 4 0 -7.108545 7.056748 3.606925 +556 1 1 0 -9.109752 4.287946 7.340476 +557 1 2 0 -10.009860 3.416611 8.055823 +558 1 2 0 -10.705939 2.327979 7.248022 +559 1 3 0 -11.556202 1.623209 7.719085 +560 1 4 0 -8.134437 4.133993 7.462110 +561 1 4 0 -9.403268 2.909131 8.828371 +562 1 4 0 -10.766691 4.008828 8.630570 +563 1 1 0 -10.238426 2.084832 5.988242 +564 1 2 0 -10.830327 1.014314 5.135787 +565 1 2 0 -10.123635 -0.408365 5.490888 +566 1 3 0 -8.886974 -0.473105 5.573450 +567 1 4 0 -9.463779 2.473999 5.471519 +568 1 4 0 -11.972825 0.862184 5.405029 +569 1 2 0 -10.573783 1.408499 3.605155 +570 1 2 0 -11.473874 2.659840 3.274246 +571 1 2 0 -10.768674 0.116838 2.675834 +572 1 2 0 -11.386046 3.100490 1.827956 +573 1 4 0 -9.497664 1.719665 3.575726 +574 1 4 0 -11.189235 3.505368 3.971634 +575 1 4 0 -12.466031 2.387035 3.608591 +576 1 4 0 -10.418619 0.285197 1.650312 +577 1 4 0 -11.889425 -0.154704 2.658339 +578 1 4 0 -10.253412 -0.844191 2.935472 +579 1 4 0 -10.489631 3.687189 1.608836 +580 1 4 0 -12.252949 3.808896 1.730836 +581 1 4 0 -11.600834 2.256313 1.164934 +582 1 1 0 -10.904182 -1.495291 5.769914 +583 1 2 0 -10.294825 -2.685192 6.266115 +584 1 2 0 -9.362686 -3.411747 5.150144 +585 1 3 0 -9.822907 -3.806655 4.048145 +586 1 4 0 -9.678597 -2.483780 7.200705 +587 1 2 0 -11.433893 -3.623279 6.740457 +588 1 2 0 -12.623002 -3.096904 5.800687 +589 1 2 0 -12.355474 -1.596314 5.926055 +590 1 4 0 -11.632975 -3.481644 7.836795 +591 1 4 0 -11.185183 -4.717775 6.760900 +592 1 4 0 -13.676441 -3.284634 6.130235 +593 1 4 0 -12.571296 -3.294434 4.749284 +594 1 4 0 -12.712668 -1.093954 6.983468 +595 1 4 0 -12.878080 -1.082331 5.087665 +596 1 1 0 -8.141305 -3.913338 5.553940 +597 1 2 0 -7.265296 -4.892156 4.877616 +598 1 2 0 -7.954629 -6.074235 4.106746 +599 1 3 0 -7.526189 -6.449816 3.017058 +600 1 4 0 -6.579043 -4.462262 4.120819 +601 1 2 0 -6.340090 -5.386881 5.987491 +602 1 2 0 -6.098980 -4.115508 6.793069 +603 1 2 0 -7.478029 -3.499220 6.819358 +604 1 4 0 -5.439953 -5.907262 5.648183 +605 1 4 0 -6.857707 -6.166813 6.603499 +606 1 4 0 -5.359728 -3.456071 6.338156 +607 1 4 0 -5.774381 -4.378426 7.875984 +608 1 4 0 -7.367742 -2.409829 6.921891 +609 1 4 0 -8.055072 -3.868224 7.656931 +610 1 1 0 -9.008919 -6.608446 4.793434 +611 1 2 0 -9.678181 -7.733135 4.285369 +612 1 2 0 -10.514900 -7.453854 3.062726 +613 1 3 0 -10.598980 -8.267352 2.099054 +614 1 4 0 -9.372380 -6.226786 5.718134 +615 1 4 0 -8.952673 -8.430078 3.800831 +616 1 2 0 -10.385978 -8.504460 5.406790 +617 1 2 0 -11.095963 -9.718862 4.959627 +618 1 3 0 -12.323382 -9.860403 5.304109 +619 1 3 0 -10.342738 -10.617376 4.418998 +620 1 4 0 -11.151852 -7.927877 5.826167 +621 1 4 0 -9.623560 -8.740853 6.193107 +622 1 1 0 -11.049078 -6.202245 2.940419 +623 1 2 0 -11.642018 -5.709443 1.705877 +624 1 2 0 -10.614336 -5.092838 0.713167 +625 1 3 0 -10.927213 -4.951138 -0.459225 +626 1 4 0 -11.081256 -5.587042 3.696816 +627 1 4 0 -11.984075 -6.605539 1.087897 +628 1 2 0 -12.768231 -4.705104 1.983069 +629 1 2 0 -13.883829 -5.316250 2.907105 +630 1 2 0 -15.114338 -4.418666 2.924881 +631 1 3 0 -15.405304 -3.917271 4.026449 +632 1 1 0 -15.906827 -4.358107 1.868346 +633 1 4 0 -13.285557 -4.431812 1.024843 +634 1 4 0 -12.425058 -3.757312 2.498081 +635 1 4 0 -13.493993 -5.422715 3.976146 +636 1 4 0 -14.172955 -6.317959 2.590855 +637 1 4 0 -15.643280 -4.761085 0.943045 +638 1 4 0 -16.887617 -4.110344 2.002905 +639 1 1 0 -9.403516 -4.718671 1.187009 +640 1 2 0 -8.418526 -4.190723 0.263736 +641 1 2 0 -7.842430 -5.239112 -0.660532 +642 1 3 0 -7.328931 -6.262671 -0.141830 +643 1 4 0 -9.039521 -4.862514 2.100989 +644 1 4 0 -8.913388 -3.436668 -0.331077 +645 1 2 0 -7.143827 -3.503558 1.041637 +646 1 2 0 -7.586437 -2.244888 1.828880 +647 1 2 0 -6.397386 -1.503568 2.513414 +648 1 3 0 -5.279630 -1.340947 1.984414 +649 1 1 0 -6.649301 -1.020214 3.747788 +650 1 4 0 -6.392988 -3.161834 0.246377 +651 1 4 0 -6.600747 -4.159050 1.729753 +652 1 4 0 -8.388106 -2.412938 2.663083 +653 1 4 0 -8.063908 -1.554062 1.129126 +654 1 4 0 -7.599327 -0.974932 4.121687 +655 1 4 0 -5.824088 -0.762663 4.379842 +656 1 1 0 -7.975739 -5.085940 -2.051099 +657 1 2 0 -7.316226 -5.859411 -3.099220 +658 1 2 0 -6.535954 -4.884159 -3.940503 +659 1 3 0 -7.016650 -4.323287 -4.885061 +660 1 4 0 -8.649330 -4.421740 -2.442279 +661 1 4 0 -6.552638 -6.577875 -2.549459 +662 1 2 0 -8.293193 -6.657174 -4.000956 +663 1 2 0 -8.951016 -7.920548 -3.205693 +664 1 2 0 -8.120004 -9.231611 -2.981077 +665 1 1 0 -7.224446 -9.317181 -1.844858 +666 1 2 0 -6.456272 -10.352566 -1.540149 +667 1 1 0 -6.261777 -11.358001 -2.422146 +668 1 1 0 -6.102837 -10.524228 -0.288739 +669 1 4 0 -7.757336 -7.047341 -4.904160 +670 1 4 0 -9.163272 -5.963583 -4.290787 +671 1 4 0 -9.924984 -8.240285 -3.732011 +672 1 4 0 -9.185465 -7.539611 -2.167170 +673 1 4 0 -7.474087 -9.426829 -3.909433 +674 1 4 0 -8.804222 -10.092199 -2.813314 +675 1 4 0 -7.241497 -8.530605 -1.089185 +676 1 4 0 -6.629122 -11.380337 -3.383889 +677 1 4 0 -5.815388 -12.216685 -2.108949 +678 1 4 0 -6.430516 -9.899279 0.447997 +679 1 4 0 -5.622476 -11.346782 -0.024111 +680 1 1 0 -5.292942 -4.653337 -3.548836 +681 1 2 0 -4.364875 -3.733621 -4.272520 +682 1 2 0 -3.884056 -4.434009 -5.580010 +683 1 3 0 -3.533279 -5.624908 -5.562725 +684 1 4 0 -4.823372 -5.284331 -2.925755 +685 1 4 0 -4.946353 -2.808529 -4.509708 +686 1 2 0 -3.111739 -3.306714 -3.368632 +687 1 2 0 -3.512923 -2.415189 -2.103271 +688 1 2 0 -2.187524 -2.216424 -1.223893 +689 1 2 0 -3.958754 -1.022674 -2.555738 +690 1 4 0 -2.365328 -2.709721 -3.991308 +691 1 4 0 -2.556390 -4.179643 -2.968211 +692 1 4 0 -4.305604 -2.923554 -1.464240 +693 1 4 0 -2.062550 -3.144793 -0.620117 +694 1 4 0 -2.115031 -1.291482 -0.497561 +695 1 4 0 -1.342308 -2.211899 -1.862143 +696 1 4 0 -3.107951 -0.478453 -3.033604 +697 1 4 0 -4.161562 -0.403495 -1.628661 +698 1 4 0 -4.885892 -1.120725 -3.194404 +699 1 1 0 -3.856496 -3.700788 -6.722801 +700 1 2 0 -3.452842 -4.182763 -8.089520 +701 1 2 0 -2.174020 -3.372729 -8.520048 +702 1 3 0 -2.088562 -2.114569 -8.327579 +703 1 4 0 -3.898301 -2.618583 -6.734908 +704 1 4 0 -3.183017 -5.236597 -7.998616 +705 1 2 0 -4.717190 -3.967990 -8.947270 +706 1 2 0 -5.895436 -4.854833 -8.519342 +707 1 2 0 -4.331848 -4.232926 -10.428080 +708 1 2 0 -5.797633 -6.318004 -8.660393 +709 1 4 0 -4.967766 -2.891891 -8.863808 +710 1 4 0 -6.807800 -4.540991 -9.113471 +711 1 4 0 -6.224024 -4.682991 -7.474756 +712 1 4 0 -5.263890 -4.453041 -11.073519 +713 1 4 0 -3.637199 -5.120375 -10.524428 +714 1 4 0 -3.762608 -3.358380 -10.861528 +715 1 4 0 -4.807288 -6.678730 -8.216144 +716 1 4 0 -5.855482 -6.587729 -9.747066 +717 1 4 0 -6.665159 -6.845883 -8.176671 +718 1 1 0 -1.222564 -4.057751 -9.205087 +719 1 2 0 -0.136624 -3.415950 -9.921138 +720 1 2 0 0.070256 -3.976880 -11.394080 +721 1 3 0 0.610536 -5.076439 -11.582664 +722 1 4 0 -1.285072 -5.056820 -9.232195 +723 1 4 0 -0.492377 -2.326993 -10.196345 +724 1 2 0 1.325233 -3.451838 -9.292553 +725 1 2 0 2.252979 -2.485580 -9.980048 +726 1 2 0 1.821424 -1.150642 -9.963953 +727 1 2 0 3.553048 -2.772749 -10.524243 +728 1 2 0 2.627188 -0.136222 -10.473998 +729 1 2 0 4.271695 -1.747890 -11.019280 +730 1 2 0 3.875296 -0.391840 -11.048201 +731 1 4 0 1.721374 -4.514315 -9.302918 +732 1 4 0 1.363608 -3.152679 -8.161531 +733 1 4 0 0.900203 -0.869990 -9.442890 +734 1 4 0 4.058655 -3.780788 -10.525233 +735 1 4 0 2.406689 0.963664 -10.402987 +736 1 4 0 5.227337 -2.093738 -11.483853 +737 1 4 0 4.613135 0.382875 -11.414402 +738 1 1 0 -0.469213 -3.209862 -12.373989 +739 1 2 0 -0.546701 -3.542255 -13.816781 +740 1 2 0 -1.166423 -4.938647 -14.104553 +741 1 3 0 -0.706356 -5.741630 -14.896149 +742 1 4 0 -0.983659 -2.328002 -12.034153 +743 1 4 0 -1.328286 -2.810564 -14.197792 +744 1 2 0 0.847710 -3.453814 -14.522754 +745 1 4 0 1.557524 -2.617362 -14.253614 +746 1 4 0 0.737328 -3.373371 -15.641978 +747 1 4 0 1.440476 -4.334496 -14.238884 +748 1 1 0 -2.318816 -5.128826 -13.446057 +749 1 2 0 -3.143886 -6.311856 -13.378529 +750 1 2 0 -2.861305 -7.249269 -12.148953 +751 1 3 0 -3.693124 -8.018797 -11.770725 +752 1 4 0 -2.759876 -4.364139 -12.830293 +753 1 4 0 -4.238045 -6.105454 -13.271863 +754 1 4 0 -3.058170 -6.943948 -14.307195 +755 1 1 0 -1.585886 -7.303614 -11.606121 +756 1 2 0 -1.141926 -8.330961 -10.575659 +757 1 2 0 -1.714720 -8.146916 -9.185538 +758 1 3 0 -1.663641 -7.016934 -8.671236 +759 1 4 0 -0.991604 -6.486688 -11.627949 +760 1 4 0 -1.432507 -9.342075 -10.930403 +761 1 2 0 0.441949 -8.242663 -10.513047 +762 1 2 0 1.115895 -8.804397 -11.798957 +763 1 2 0 2.659392 -8.559556 -11.862927 +764 1 2 0 3.525297 -9.477008 -11.044076 +765 1 1 0 4.928913 -9.126450 -11.049928 +766 1 4 0 0.930008 -8.793558 -9.704840 +767 1 4 0 0.820281 -7.154573 -10.383627 +768 1 4 0 0.726808 -8.346899 -12.740661 +769 1 4 0 0.816642 -9.905594 -11.898832 +770 1 4 0 2.766554 -7.492314 -11.630235 +771 1 4 0 2.990272 -8.709413 -12.938787 +772 1 4 0 3.480243 -10.547229 -11.281436 +773 1 4 0 3.142144 -9.394311 -9.993141 +774 1 4 0 5.380243 -9.145878 -11.941964 +775 1 4 0 5.445854 -9.749951 -10.436478 +776 1 4 0 5.117208 -8.202842 -10.744769 +777 1 1 0 -2.261410 -9.249088 -8.588259 +778 1 2 0 -2.615396 -9.233499 -7.225533 +779 1 2 0 -1.335567 -8.948793 -6.438233 +780 1 3 0 -0.279868 -9.480653 -6.690356 +781 1 4 0 -2.255352 -10.169786 -9.074177 +782 1 4 0 -3.334713 -8.420685 -7.023961 +783 1 2 0 -3.251131 -10.563774 -6.767452 +784 1 2 0 -4.535149 -10.474262 -6.008036 +785 1 2 0 -4.398618 -9.939824 -4.513090 +786 1 3 0 -5.077126 -8.969050 -4.171499 +787 1 1 0 -3.545204 -10.582628 -3.678241 +788 1 4 0 -2.536808 -11.208918 -6.196239 +789 1 4 0 -3.428126 -11.121298 -7.678818 +790 1 4 0 -4.970296 -11.490264 -5.897297 +791 1 4 0 -5.221487 -9.801148 -6.555491 +792 1 4 0 -3.257694 -11.568395 -3.807768 +793 1 4 0 -3.345020 -10.122941 -2.746863 +794 1 1 0 -1.450039 -8.014788 -5.496898 +795 1 2 0 -0.421843 -7.645217 -4.599782 +796 1 2 0 -0.664467 -8.314648 -3.266854 +797 1 3 0 -1.615751 -8.129338 -2.521866 +798 1 4 0 -2.373522 -7.541372 -5.361698 +799 1 4 0 0.525104 -7.914594 -5.012102 +800 1 2 0 -0.361457 -6.082978 -4.502645 +801 1 2 0 0.013954 -5.455430 -5.851982 +802 1 2 0 0.049019 -3.957376 -5.617040 +803 1 2 0 1.428022 -5.979157 -6.227374 +804 1 4 0 0.435555 -5.929917 -3.703749 +805 1 4 0 -1.370222 -5.613724 -4.112042 +806 1 4 0 -0.783872 -5.696630 -6.601592 +807 1 4 0 -0.918682 -3.670337 -5.057847 +808 1 4 0 -0.051016 -3.481788 -6.645675 +809 1 4 0 0.927863 -3.578685 -5.148034 +810 1 4 0 1.304895 -7.011135 -6.510945 +811 1 4 0 2.256941 -6.075607 -5.425529 +812 1 4 0 1.836340 -5.473788 -7.076509 +813 1 1 0 0.008587 -9.534155 -3.176981 +814 1 2 0 -0.164006 -10.610017 -2.276861 +815 1 2 0 0.455793 -10.123372 -0.937523 +816 1 3 0 1.609433 -9.732719 -0.855349 +817 1 4 0 0.661532 -9.822276 -3.993714 +818 1 4 0 -1.244755 -10.767542 -2.035039 +819 1 2 0 0.574437 -11.905679 -2.866050 +820 1 2 0 0.334302 -13.196441 -2.052243 +821 1 2 0 0.695999 -13.209957 -0.547494 +822 1 3 0 -0.264686 -13.183024 0.298109 +823 1 3 0 1.910632 -13.459361 -0.183932 +824 1 4 0 1.710862 -11.775851 -2.827976 +825 1 4 0 0.358791 -11.917380 -3.993445 +826 1 4 0 0.882365 -13.997962 -2.620937 +827 1 4 0 -0.759904 -13.530227 -2.138213 +828 1 1 0 -0.357453 -10.118381 0.156881 +829 1 2 0 -0.126858 -9.579761 1.459753 +830 1 2 0 1.210865 -9.885856 2.201894 +831 1 3 0 1.578355 -9.098965 3.087348 +832 1 4 0 -1.314386 -10.278297 -0.048400 +833 1 4 0 -0.027285 -8.417312 1.375403 +834 1 2 0 -1.323443 -9.874534 2.428279 +835 1 2 0 -2.796658 -9.594191 2.040205 +836 1 3 0 -3.598938 -8.858694 2.747148 +837 1 3 0 -3.069275 -9.875155 0.835441 +838 1 4 0 -1.081085 -9.350501 3.331576 +839 1 4 0 -1.329114 -10.904878 2.757681 +840 1 1 0 1.774130 -11.086092 1.992881 +841 1 2 0 2.994120 -11.545091 2.708587 +842 1 2 0 4.377665 -11.351494 1.943197 +843 1 3 0 5.433148 -11.274449 2.624196 +844 1 4 0 1.231410 -11.794245 1.490134 +845 1 4 0 3.087086 -10.934376 3.717487 +846 1 4 0 2.994182 -12.632411 2.994368 +847 1 1 0 4.334836 -11.180015 0.643592 +848 1 2 0 5.298784 -10.617673 -0.256284 +849 1 2 0 5.545436 -9.161422 0.121481 +850 1 3 0 4.681756 -8.523001 0.675460 +851 1 4 0 3.389098 -11.194600 0.224796 +852 1 4 0 6.302556 -11.051188 -0.027697 +853 1 2 0 4.842303 -10.729803 -1.752153 +854 1 2 0 4.713323 -12.135756 -2.446341 +855 1 2 0 5.630639 -13.213151 -1.906582 +856 1 1 0 5.284941 -13.736409 -0.601898 +857 1 2 0 6.075566 -13.904284 0.492928 +858 1 1 0 7.378324 -13.682239 0.392183 +859 1 1 0 5.537046 -14.223213 1.666359 +860 1 4 0 5.533031 -10.123030 -2.400529 +861 1 4 0 3.921522 -10.207566 -1.834451 +862 1 4 0 4.892154 -12.013932 -3.582693 +863 1 4 0 3.646766 -12.426728 -2.380513 +864 1 4 0 6.696275 -12.970967 -1.977244 +865 1 4 0 5.489916 -14.113101 -2.629388 +866 1 4 0 4.272537 -13.863270 -0.494816 +867 1 4 0 7.985377 -13.700052 -0.424821 +868 1 4 0 7.940470 -13.667672 1.245648 +869 1 4 0 4.531855 -14.502228 1.787659 +870 1 4 0 6.101298 -14.389973 2.557369 +871 1 1 0 6.795959 -8.709417 -0.229618 +872 1 2 0 7.151484 -7.314826 -0.044504 +873 1 2 0 6.772152 -6.618863 -1.344791 +874 1 3 0 6.491580 -7.195037 -2.353138 +875 1 4 0 7.318576 -9.171415 -1.002843 +876 1 4 0 6.525833 -6.859535 0.829338 +877 1 2 0 8.635451 -7.121669 0.159249 +878 1 3 0 9.319110 -7.714935 -0.864105 +879 1 2 0 9.122393 -7.761915 1.542275 +880 1 4 0 8.861381 -6.006942 0.177513 +881 1 4 0 10.194312 -7.422946 -0.650194 +882 1 4 0 10.121810 -7.432113 1.729501 +883 1 4 0 9.135396 -8.869565 1.459149 +884 1 4 0 8.446951 -7.382073 2.362364 +885 1 1 0 6.963090 -5.264591 -1.254451 +886 1 2 0 6.942143 -4.382454 -2.396821 +887 1 2 0 8.032255 -4.727919 -3.355290 +888 1 3 0 7.874094 -4.700903 -4.606280 +889 1 4 0 7.090170 -4.902090 -0.328807 +890 1 4 0 6.016462 -4.502766 -2.986232 +891 1 2 0 7.011823 -2.893701 -1.884788 +892 1 2 0 5.619258 -2.371640 -1.146601 +893 1 2 0 5.747407 -0.832171 -0.836537 +894 1 2 0 4.304852 -2.632042 -1.932473 +895 1 4 0 7.232530 -2.302129 -2.742395 +896 1 4 0 7.918264 -2.789406 -1.123344 +897 1 4 0 5.453202 -2.916654 -0.186086 +898 1 4 0 4.887008 -0.456110 -0.323416 +899 1 4 0 5.896335 -0.152245 -1.791542 +900 1 4 0 6.670665 -0.673450 -0.254409 +901 1 4 0 4.181643 -2.082693 -2.916672 +902 1 4 0 3.442444 -2.383879 -1.330292 +903 1 4 0 4.282395 -3.716052 -2.117091 +904 1 1 0 9.237825 -5.055680 -2.844670 +905 1 2 0 10.327506 -5.326158 -3.751795 +906 1 2 0 10.299712 -6.687552 -4.448700 +907 1 3 0 11.020799 -6.802866 -5.444496 +908 1 4 0 9.513335 -4.765910 -1.839355 +909 1 4 0 10.385954 -4.560168 -4.527939 +910 1 2 0 11.616785 -5.225390 -2.849555 +911 1 3 0 11.681845 -6.184576 -1.811464 +912 1 4 0 11.731770 -4.245308 -2.404822 +913 1 4 0 12.479811 -5.484003 -3.480128 +914 1 4 0 12.247855 -6.858858 -2.142458 +915 1 1 0 9.390895 -7.583629 -4.036730 +916 1 2 0 8.992160 -8.754252 -4.825764 +917 1 2 0 8.441950 -8.325775 -6.179531 +918 1 3 0 8.453951 -9.076338 -7.106677 +919 1 4 0 8.901001 -7.489208 -3.091813 +920 1 4 0 10.003891 -9.220020 -5.018515 +921 1 2 0 8.053488 -9.759256 -4.183158 +922 1 2 0 8.636121 -10.682406 -3.119472 +923 1 3 0 8.285666 -10.472382 -1.922177 +924 1 3 0 9.461725 -11.579888 -3.491527 +925 1 4 0 7.570077 -10.438277 -4.930342 +926 1 4 0 7.245571 -9.201184 -3.714526 +927 1 1 0 7.768214 -7.119718 -6.199610 +928 1 2 0 7.005887 -6.638728 -7.315257 +929 1 2 0 7.851617 -5.582566 -8.113333 +930 1 3 0 7.595614 -5.232955 -9.268020 +931 1 4 0 7.640444 -6.594365 -5.349903 +932 1 4 0 6.951423 -7.445998 -8.104085 +933 1 2 0 5.604718 -6.020286 -6.971603 +934 1 2 0 4.808080 -7.258931 -6.484822 +935 1 2 0 4.589395 -7.461018 -5.120438 +936 1 2 0 4.447069 -8.273894 -7.429155 +937 1 2 0 3.784056 -8.535024 -4.755017 +938 1 2 0 3.579283 -9.310814 -7.055696 +939 1 2 0 3.326057 -9.397762 -5.690539 +940 1 3 0 2.439893 -10.287138 -5.195207 +941 1 4 0 5.141919 -5.567564 -7.921399 +942 1 4 0 5.606057 -5.151689 -6.311062 +943 1 4 0 4.944905 -6.731723 -4.350204 +944 1 4 0 4.660459 -8.167346 -8.489786 +945 1 4 0 3.457378 -8.750277 -3.665145 +946 1 4 0 3.267954 -10.081994 -7.761989 +947 1 4 0 2.186803 -10.747811 -5.996630 +948 1 1 0 8.902051 -5.011864 -7.407302 +949 1 2 0 9.703612 -3.896573 -7.971331 +950 1 2 0 8.854605 -2.738907 -8.339936 +951 1 3 0 9.065146 -2.145748 -9.384005 +952 1 4 0 9.116746 -5.266463 -6.458188 +953 1 4 0 10.386108 -3.586461 -7.092001 +954 1 2 0 10.578732 -4.353776 -9.179322 +955 1 2 0 11.689249 -3.400850 -9.487746 +956 1 3 0 11.683048 -2.729553 -10.505813 +957 1 1 0 12.685159 -3.379988 -8.534891 +958 1 4 0 9.859055 -4.483921 -10.059621 +959 1 4 0 11.053015 -5.363302 -8.978055 +960 1 4 0 12.816952 -4.073113 -7.744033 +961 1 4 0 13.500082 -2.669172 -8.653591 +962 1 1 0 7.961974 -2.346899 -7.450123 +963 1 2 0 7.210073 -1.082393 -7.353242 +964 1 2 0 8.220074 -0.014005 -6.989916 +965 1 3 0 8.976625 -0.122583 -6.038982 +966 1 4 0 7.839428 -2.859206 -6.569147 +967 1 4 0 6.707337 -0.850947 -8.383918 +968 1 2 0 6.030095 -1.285349 -6.242570 +969 1 2 0 4.899744 -1.930604 -7.085273 +970 1 2 0 5.645671 -0.002619 -5.492558 +971 1 2 0 3.850643 -2.639039 -6.295674 +972 1 4 0 6.419510 -1.908236 -5.417144 +973 1 4 0 5.364352 -2.708104 -7.784017 +974 1 4 0 4.483419 -1.167649 -7.800574 +975 1 4 0 5.004870 -0.066649 -4.602552 +976 1 4 0 5.129294 0.689353 -6.215366 +977 1 4 0 6.560668 0.460605 -5.074466 +978 1 4 0 3.234235 -1.930388 -5.649940 +979 1 4 0 4.384891 -3.374819 -5.577049 +980 1 4 0 3.162458 -3.233503 -6.928627 +981 1 1 0 8.279015 1.096767 -7.735473 +982 1 2 0 9.149500 2.177313 -7.448918 +983 1 2 0 8.443049 3.455173 -7.091881 +984 1 3 0 7.225838 3.588535 -7.314849 +985 1 4 0 7.643874 1.078344 -8.517521 +986 1 4 0 9.726155 1.989811 -6.530547 +987 1 2 0 10.141562 2.393897 -8.637297 +988 1 2 0 11.175363 1.278751 -8.856450 +989 1 2 0 12.297979 1.259017 -7.866598 +990 1 3 0 13.426383 1.600621 -8.288936 +991 1 1 0 12.128586 0.499484 -6.748544 +992 1 4 0 10.711669 3.336580 -8.503837 +993 1 4 0 9.628679 2.543322 -9.607849 +994 1 4 0 11.602578 1.390889 -9.880921 +995 1 4 0 10.646349 0.304077 -8.758295 +996 1 4 0 11.162328 0.324257 -6.474357 +997 1 4 0 12.859952 0.645961 -6.011600 +998 1 1 0 9.290608 4.442003 -6.647564 +999 1 2 0 8.811159 5.826111 -6.212163 +1000 1 2 0 7.909587 6.365352 -7.395189 +1001 1 3 0 8.277887 6.147537 -8.576688 +1002 1 4 0 10.326040 4.354253 -6.566650 +1003 1 4 0 8.074366 5.700259 -5.392561 +1004 1 2 0 9.995835 6.763127 -5.753453 +1005 1 2 0 11.134989 6.936166 -6.773871 +1006 1 2 0 12.450245 7.429690 -6.051861 +1007 1 2 0 12.385757 8.858415 -5.565813 +1008 1 1 0 13.633988 9.413177 -5.138817 +1009 1 4 0 10.292905 6.307034 -4.826845 +1010 1 4 0 9.733735 7.849575 -5.494064 +1011 1 4 0 10.808074 7.681538 -7.552779 +1012 1 4 0 11.297990 5.963599 -7.337475 +1013 1 4 0 13.159036 7.413697 -6.874982 +1014 1 4 0 12.808296 6.686485 -5.298299 +1015 1 4 0 11.641999 8.947159 -4.656213 +1016 1 4 0 11.959207 9.504307 -6.407475 +1017 1 4 0 13.653846 10.372301 -4.854541 +1018 1 4 0 14.288544 9.333898 -5.904378 +1019 1 4 0 14.092755 8.836443 -4.392426 +1020 1 1 0 6.734291 6.959000 -7.083862 +1021 1 2 0 5.689140 7.483124 -7.928906 +1022 1 2 0 4.722565 6.430009 -8.546693 +1023 1 3 0 3.693452 6.803359 -9.036911 +1024 1 4 0 6.540297 7.080673 -6.102459 +1025 1 4 0 4.958282 8.082892 -7.282649 +1026 1 2 0 6.303009 8.338869 -9.147185 +1027 1 2 0 6.962321 9.683020 -8.698706 +1028 1 2 0 6.113335 10.806050 -8.094806 +1029 1 3 0 5.314957 11.441914 -8.867803 +1030 1 3 0 6.281814 11.153556 -6.860003 +1031 1 4 0 5.501095 8.608142 -9.829181 +1032 1 4 0 7.017775 7.642829 -9.688511 +1033 1 4 0 7.483003 10.111296 -9.587458 +1034 1 4 0 7.840208 9.443341 -8.067185 +1035 1 1 0 4.989573 5.171451 -8.501981 +1036 1 2 0 4.030569 4.128878 -8.960795 +1037 1 2 0 2.659803 4.362057 -8.317970 +1038 1 3 0 2.633685 4.624499 -7.137127 +1039 1 4 0 5.932873 4.885550 -8.132184 +1040 1 4 0 3.970653 4.088976 -10.125056 +1041 1 2 0 4.547974 2.736928 -8.477716 +1042 1 3 0 5.739602 2.385810 -9.103937 +1043 1 4 0 3.830289 1.946588 -8.750291 +1044 1 4 0 4.757904 2.775726 -7.322086 +1045 1 4 0 6.399052 2.573026 -8.460448 +1046 1 1 0 1.554928 4.204648 -9.116288 +1047 1 2 0 0.143907 4.283937 -8.678656 +1048 1 2 0 -0.303717 2.830944 -8.588594 +1049 1 3 0 -0.192844 2.048979 -9.526722 +1050 1 4 0 1.755361 3.846256 -10.076285 +1051 1 4 0 0.145346 4.729291 -7.623107 +1052 1 2 0 -0.896382 4.990465 -9.602777 +1053 1 3 0 -0.546909 6.390258 -9.553197 +1054 1 2 0 -2.266687 5.014292 -9.040912 +1055 1 4 0 -0.839484 4.664962 -10.623152 +1056 1 4 0 -1.191403 6.852676 -10.030026 +1057 1 4 0 -2.370256 5.547925 -8.077780 +1058 1 4 0 -2.643323 3.985031 -8.945267 +1059 1 4 0 -3.015295 5.554521 -9.684458 +1060 1 1 0 -0.809824 2.397412 -7.387791 +1061 1 2 0 -1.543539 1.146508 -7.125034 +1062 1 2 0 -2.990030 1.446385 -7.471646 +1063 1 3 0 -3.473985 2.523645 -7.085299 +1064 1 4 0 -0.918513 3.078458 -6.559929 +1065 1 4 0 -1.082428 0.391021 -7.805730 +1066 1 2 0 -1.383109 0.737389 -5.704209 +1067 1 2 0 0.156980 0.778637 -5.025094 +1068 1 2 0 0.184063 0.045177 -3.655495 +1069 1 2 0 1.197637 0.213126 -5.986021 +1070 1 4 0 -1.814061 -0.254567 -5.578464 +1071 1 4 0 -2.073414 1.403223 -5.171331 +1072 1 4 0 0.570353 1.840354 -4.807618 +1073 1 4 0 -0.614353 0.329349 -2.926832 +1074 1 4 0 1.166261 0.241414 -3.114555 +1075 1 4 0 0.023700 -1.069031 -3.783533 +1076 1 4 0 2.158203 0.044818 -5.470973 +1077 1 4 0 1.222442 1.006598 -6.769381 +1078 1 4 0 0.965216 -0.653562 -6.606231 +1079 1 1 0 -3.781136 0.498160 -8.148625 +1080 1 2 0 -5.195999 0.627079 -8.395144 +1081 1 2 0 -5.839586 -0.173798 -7.325540 +1082 1 3 0 -5.682825 -1.396726 -7.207748 +1083 1 4 0 -3.423672 -0.475658 -8.058410 +1084 1 4 0 -5.466443 1.726348 -8.275345 +1085 1 2 0 -5.700075 0.093076 -9.698941 +1086 1 2 0 -5.439579 1.075796 -10.855403 +1087 1 1 0 -6.279526 2.029710 -11.458307 +1088 1 2 0 -4.192293 1.220658 -11.582303 +1089 1 2 0 -5.690995 2.592928 -12.533727 +1090 1 1 0 -4.422291 2.142927 -12.597346 +1091 1 4 0 -6.836699 -0.066381 -9.723009 +1092 1 4 0 -5.265040 -0.930234 -9.855749 +1093 1 4 0 -7.252692 2.264574 -11.108175 +1094 1 4 0 -3.349838 0.582035 -11.517840 +1095 1 4 0 -6.306793 3.255586 -13.155877 +1096 1 4 0 -3.777635 2.395819 -13.330102 +1097 1 1 0 -6.626714 0.438016 -6.407006 +1098 1 2 0 -7.321255 -0.209395 -5.260830 +1099 1 2 0 -8.726044 -0.540624 -5.779334 +1100 1 3 0 -9.643748 0.246853 -6.020516 +1101 1 4 0 -6.861887 1.458160 -6.506142 +1102 1 4 0 -6.783811 -1.126314 -4.931556 +1103 1 2 0 -7.394204 0.687745 -4.053531 +1104 1 2 0 -8.296909 0.064749 -2.869849 +1105 1 2 0 -7.951698 -1.454279 -2.487926 +1106 1 2 0 -8.060038 0.927044 -1.568059 +1107 1 4 0 -7.854595 1.761490 -4.347062 +1108 1 4 0 -6.360197 0.997945 -3.694450 +1109 1 4 0 -9.450918 0.148422 -3.062584 +1110 1 4 0 -7.020548 -1.637465 -1.993488 +1111 1 4 0 -7.993278 -2.155479 -3.352501 +1112 1 4 0 -8.718116 -1.826418 -1.776705 +1113 1 4 0 -6.906806 1.040935 -1.329769 +1114 1 4 0 -8.507678 0.388091 -0.676703 +1115 1 4 0 -8.513627 1.951825 -1.684662 +1116 1 1 0 -8.874500 -1.873711 -5.910632 +1117 1 2 0 -10.054693 -2.628336 -6.198564 +1118 1 2 0 -10.572111 -3.015072 -4.753004 +1119 1 3 0 -9.832635 -3.443205 -3.816546 +1120 1 4 0 -7.996568 -2.422971 -5.836674 +1121 1 4 0 -10.870694 -1.994424 -6.483439 +1122 1 2 0 -9.759279 -3.959835 -7.069730 +1123 1 2 0 -10.946970 -4.877626 -7.068986 +1124 1 2 0 -9.371460 -3.542046 -8.470112 +1125 1 4 0 -8.949402 -4.516022 -6.543614 +1126 1 4 0 -11.541359 -4.965020 -6.098983 +1127 1 4 0 -10.625500 -5.914327 -7.249472 +1128 1 4 0 -11.748695 -4.562709 -7.779917 +1129 1 4 0 -8.371018 -3.050033 -8.468892 +1130 1 4 0 -10.059019 -2.758287 -8.851634 +1131 1 4 0 -9.340042 -4.349447 -9.290806 +1132 1 1 0 -11.926250 -3.006119 -4.579854 +1133 1 2 0 -12.599868 -3.427499 -3.271795 +1134 1 2 0 -13.119425 -4.819080 -3.443024 +1135 1 3 0 -13.506292 -5.208366 -4.502651 +1136 1 4 0 -12.484786 -2.940272 -5.402807 +1137 1 4 0 -11.809544 -3.497303 -2.534649 +1138 1 2 0 -13.689712 -2.401148 -2.755481 +1139 1 2 0 -13.005610 -1.020901 -2.289793 +1140 1 2 0 -13.886801 0.170603 -2.491323 +1141 1 2 0 -12.530133 -1.092500 -0.802600 +1142 1 4 0 -14.252193 -2.898736 -1.884096 +1143 1 4 0 -14.401815 -2.226641 -3.620690 +1144 1 4 0 -12.072590 -0.884860 -2.820312 +1145 1 4 0 -13.445227 1.217778 -2.222189 +1146 1 4 0 -14.793098 0.063548 -1.909740 +1147 1 4 0 -14.187182 0.152067 -3.578149 +1148 1 4 0 -13.308581 -1.365227 -0.079185 +1149 1 4 0 -12.103016 -0.144811 -0.412295 +1150 1 4 0 -11.612023 -1.776214 -0.714294 +1151 1 1 0 -13.156998 -5.622978 -2.323616 +1152 1 2 0 -13.787861 -6.967978 -2.285282 +1153 1 2 0 -15.146212 -6.800506 -1.593340 +1154 1 3 0 -15.158053 -6.442067 -0.396674 +1155 1 4 0 -12.804286 -5.282526 -1.428142 +1156 1 4 0 -13.916618 -7.485164 -3.412935 +1157 1 2 0 -12.946414 -7.979280 -1.497063 +1158 1 2 0 -13.667631 -9.245528 -0.905442 +1159 1 2 0 -12.815857 -10.499980 -0.801429 +1160 1 1 0 -11.666913 -10.382988 0.124040 +1161 1 2 0 -10.598009 -11.176366 0.312631 +1162 1 1 0 -10.307009 -12.288930 -0.364431 +1163 1 1 0 -9.633279 -10.774307 1.106366 +1164 1 4 0 -12.386465 -7.607216 -0.581206 +1165 1 4 0 -12.215820 -8.370972 -2.244713 +1166 1 4 0 -14.479446 -9.568262 -1.529164 +1167 1 4 0 -14.129833 -9.168539 0.056180 +1168 1 4 0 -12.412465 -10.669174 -1.854364 +1169 1 4 0 -13.466079 -11.423733 -0.479836 +1170 1 4 0 -11.512692 -9.382182 0.495625 +1171 1 4 0 -10.805304 -12.650925 -1.216224 +1172 1 4 0 -9.470321 -12.815770 -0.049797 +1173 1 4 0 -9.791948 -9.915404 1.677222 +1174 1 4 0 -8.883682 -11.348748 1.394071 +1175 1 1 0 -16.257217 -7.220554 -2.308703 +1176 1 2 0 -17.613518 -7.141694 -1.748926 +1177 1 2 0 -17.781416 -8.219845 -0.663951 +1178 1 3 0 -17.284390 -9.348310 -0.956865 +1179 1 4 0 -16.199694 -7.696122 -3.255195 +1180 1 4 0 -17.779696 -6.166353 -1.252915 +1181 1 2 0 -18.748459 -7.363962 -2.843069 +1182 1 2 0 -18.849202 -6.260828 -3.989572 +1183 1 2 0 -19.614490 -6.870808 -5.148395 +1184 1 2 0 -19.500680 -4.982113 -3.494742 +1185 1 4 0 -19.731301 -7.397251 -2.283025 +1186 1 4 0 -18.632820 -8.422553 -3.243609 +1187 1 4 0 -17.781339 -6.071752 -4.343559 +1188 1 4 0 -19.542258 -6.264447 -6.144731 +1189 1 4 0 -20.684366 -6.894552 -4.987517 +1190 1 4 0 -19.302207 -7.942787 -5.285929 +1191 1 4 0 -19.636746 -4.174795 -4.365113 +1192 1 4 0 -18.901688 -4.545004 -2.684455 +1193 1 4 0 -20.591982 -5.186371 -3.176857 +1194 1 1 0 -18.472240 -7.923944 0.433190 +1195 1 2 0 -18.558377 -8.661913 1.684016 +1196 1 2 0 -19.865592 -8.197617 2.423657 +1197 1 3 0 -20.225574 -7.007408 2.517047 +1198 1 4 0 -19.018633 -7.045923 0.383040 +1199 1 4 0 -18.591712 -9.815151 1.449892 +1200 1 2 0 -17.330534 -8.352242 2.590189 +1201 1 2 0 -17.197501 -9.255175 3.894695 +1202 1 2 0 -15.917138 -8.993799 4.761448 +1203 1 1 0 -15.862754 -7.604311 5.340549 +1204 1 2 0 -14.953946 -7.213621 6.222257 +1205 1 1 0 -13.939504 -7.925565 6.768523 +1206 1 1 0 -15.231901 -6.019110 6.758979 +1207 1 4 0 -17.334188 -7.257380 2.696147 +1208 1 4 0 -16.422266 -8.568012 1.978366 +1209 1 4 0 -17.281791 -10.298139 3.520877 +1210 1 4 0 -18.121600 -9.053051 4.460330 +1211 1 4 0 -14.891329 -9.193895 4.266694 +1212 1 4 0 -16.028045 -9.747706 5.563074 +1213 1 4 0 -16.694442 -6.992689 5.266552 +1214 1 4 0 -13.473108 -8.806088 6.384760 +1215 1 4 0 -13.382022 -7.560903 7.513773 +1216 1 4 0 -16.061939 -5.573954 6.401806 +1217 1 4 0 -14.719788 -5.491070 7.406533 +1218 1 1 0 -20.555642 -9.238644 2.984101 +1219 1 2 0 -21.702627 -8.980829 3.816986 +1220 1 2 0 -22.667592 -10.144922 3.908536 +1221 1 3 0 -23.356911 -10.299018 4.988328 +1222 1 4 0 -20.172384 -10.204330 3.007070 +1223 1 4 0 -21.390921 -8.619000 4.839945 +1224 1 4 0 -22.324153 -8.174944 3.384408 +1225 1 1 0 -22.722375 -11.026698 2.860636 +1226 1 2 0 -23.459566 -12.247827 2.845542 +1227 1 2 0 -22.978621 -13.438108 1.985225 +1228 1 3 0 -23.756241 -13.995796 1.178096 +1229 1 4 0 -22.154953 -11.003456 1.998676 +1230 1 4 0 -23.492303 -12.585024 3.945342 +1231 1 4 0 -24.562029 -11.982169 2.632418 +1232 1 3 0 -21.741623 -13.731454 2.030156 +1233 2 6 0 -25.305889 -8.873286 2.603094 +1234 2 4 0 -26.195231 -8.788006 2.967312 +1235 2 4 0 -25.362163 -9.790033 2.275871 +1236 3 6 0 1.912477 -17.151817 -13.840126 +1237 3 4 0 1.018390 -17.464992 -13.630219 +1238 3 4 0 2.439262 -17.334772 -13.036215 +1239 4 6 0 8.975970 -6.483371 7.068342 +1240 4 4 0 8.251083 -5.855922 6.942323 +1241 4 4 0 9.786320 -5.989537 6.904165 +1242 5 6 0 -17.059429 -6.682892 -18.382532 +1243 5 4 0 -17.356881 -6.533480 -19.279335 +1244 5 4 0 -16.147993 -6.804945 -18.480643 +1245 6 6 0 11.369980 -7.303894 20.323145 +1246 6 4 0 10.458255 -7.203431 20.535809 +1247 6 4 0 11.777545 -7.941380 20.905100 +1248 7 6 0 3.047993 13.115234 13.513593 +1249 7 4 0 2.189597 12.815932 13.781761 +1250 7 4 0 3.351020 13.772449 14.197587 +1251 8 6 0 9.177488 -19.531354 -17.025005 +1252 8 4 0 8.997180 -19.923922 -17.884170 +1253 8 4 0 8.309703 -19.391487 -16.606802 +1254 9 6 0 -23.848340 -5.791211 7.441678 +1255 9 4 0 -24.004055 -6.746691 7.261738 +1256 9 4 0 -23.114081 -5.501409 6.867622 +1257 10 6 0 20.312209 0.171955 -11.773561 +1258 10 4 0 20.146745 1.095650 -12.020368 +1259 10 4 0 21.238842 0.205679 -11.456820 +1260 11 6 0 -22.314798 3.014770 5.149047 +1261 11 4 0 -22.929289 2.276522 4.980524 +1262 11 4 0 -22.201264 3.090196 6.138941 +1263 12 6 0 26.239381 8.286972 11.597675 +1264 12 4 0 26.254621 7.398022 11.997034 +1265 12 4 0 26.842192 8.820608 12.190091 +1266 13 6 0 1.081563 20.255845 0.892389 +1267 13 4 0 0.921065 19.278377 0.845371 +1268 13 4 0 1.812904 20.277503 0.290341 +1269 14 6 0 -25.838005 -18.994104 1.429638 +1270 14 4 0 -26.326160 -18.188143 1.703932 +1271 14 4 0 -25.342908 -19.303427 2.200872 +1272 15 6 0 -20.846054 -7.092652 6.478370 +1273 15 4 0 -20.166552 -7.554414 6.018306 +1274 15 4 0 -21.115422 -7.596368 7.225200 +1275 16 6 0 25.160173 -4.728893 -15.381523 +1276 16 4 0 24.661069 -4.062502 -14.979503 +1277 16 4 0 25.990165 -4.238213 -15.567710 +1278 17 6 0 14.535913 -19.677013 15.675709 +1279 17 4 0 14.037278 -20.588075 15.600840 +1280 17 4 0 14.211502 -19.181601 14.912412 +1281 18 6 0 2.857645 5.855417 4.079262 +1282 18 4 0 3.430506 5.710138 4.830199 +1283 18 4 0 2.475458 6.741420 4.276791 +1284 19 6 0 -27.372739 -15.194690 -19.205198 +1285 19 4 0 -28.210581 -15.653921 -19.162899 +1286 19 4 0 -27.456185 -14.667250 -19.960242 +1287 20 6 0 17.781541 0.602750 -19.513277 +1288 20 4 0 17.110642 0.664367 -18.792643 +1289 20 4 0 18.099117 1.530660 -19.555262 +1290 21 6 0 8.088032 9.439765 10.567445 +1291 21 4 0 8.015346 10.287070 10.169518 +1292 21 4 0 8.124832 9.462611 11.569641 +1293 22 6 0 15.345860 8.714934 -11.152067 +1294 22 4 0 15.658920 9.075500 -11.972725 +1295 22 4 0 14.523818 9.211910 -11.028938 +1296 23 6 0 11.013253 17.283874 -4.348263 +1297 23 4 0 10.789838 18.205570 -4.504969 +1298 23 4 0 10.260676 16.779106 -4.055437 +1299 24 6 0 -12.889592 -16.760154 20.387880 +1300 24 4 0 -13.380671 -16.152118 19.799845 +1301 24 4 0 -13.369275 -16.639729 21.191087 +1302 25 6 0 25.866516 4.706708 -8.061449 +1303 25 4 0 25.769362 4.461317 -8.965208 +1304 25 4 0 25.764828 5.656105 -8.114825 +1305 26 6 0 -26.248807 10.809987 -17.556369 +1306 26 4 0 -25.862537 10.639607 -16.669023 +1307 26 4 0 -25.586772 10.275331 -18.075376 +1308 27 6 0 5.011891 -0.095276 11.102149 +1309 27 4 0 5.950070 -0.328570 10.928116 +1310 27 4 0 4.658035 -0.692033 11.838618 +1311 28 6 0 -3.238023 12.776925 -11.754925 +1312 28 4 0 -3.559468 13.177496 -12.562608 +1313 28 4 0 -2.242036 12.949361 -11.730152 +1314 29 6 0 7.608155 6.209090 6.533228 +1315 29 4 0 6.751309 6.368791 6.939913 +1316 29 4 0 7.470608 5.288476 6.273733 +1317 30 6 0 14.666135 -14.922987 -11.755230 +1318 30 4 0 14.581988 -14.800079 -10.784928 +1319 30 4 0 15.226569 -14.207434 -12.104465 +1320 31 6 0 15.326386 3.732831 -20.745668 +1321 31 4 0 14.863781 4.277641 -20.063559 +1322 31 4 0 14.723700 3.157686 -21.298124 +1323 32 6 0 18.627348 -11.469990 6.467592 +1324 32 4 0 19.047503 -12.239416 6.986935 +1325 32 4 0 19.345653 -10.823603 6.332871 +1326 33 6 0 -14.220347 1.309533 12.809953 +1327 33 4 0 -15.112916 1.674865 12.966390 +1328 33 4 0 -13.905824 1.691626 11.972749 +1329 34 6 0 17.738294 20.743473 -0.318702 +1330 34 4 0 16.798924 21.074482 -0.373811 +1331 34 4 0 18.299449 21.160545 -1.000515 +1332 35 6 0 20.455752 2.132791 12.340284 +1333 35 4 0 19.810773 1.395571 12.257305 +1334 35 4 0 20.198026 2.647549 11.503824 +1335 36 6 0 9.853022 -4.726683 18.073966 +1336 36 4 0 9.922207 -4.319154 18.942345 +1337 36 4 0 10.745493 -4.795112 17.634995 +1338 37 6 0 22.828162 7.406766 18.911442 +1339 37 4 0 23.277041 7.740752 18.085874 +1340 37 4 0 21.875678 7.287001 18.697167 +1341 38 6 0 12.857348 6.858682 -2.850558 +1342 38 4 0 12.349544 7.638411 -2.700800 +1343 38 4 0 13.434641 6.773930 -2.100368 +1344 39 6 0 10.156535 2.406121 -18.658294 +1345 39 4 0 10.409878 1.989225 -19.465922 +1346 39 4 0 9.490048 3.103188 -18.852928 +1347 40 6 0 12.554233 20.216080 19.570476 +1348 40 4 0 11.705682 19.810667 19.782475 +1349 40 4 0 12.468266 20.347772 18.588160 +1350 41 6 0 -1.134276 6.357754 18.934733 +1351 41 4 0 -1.973226 6.075942 19.245633 +1352 41 4 0 -0.442075 6.043387 19.552910 +1353 42 6 0 1.750577 4.009032 13.244051 +1354 42 4 0 1.218838 4.545834 13.791599 +1355 42 4 0 1.398756 3.100724 13.349288 +1356 43 6 0 2.689021 16.465513 4.587974 +1357 43 4 0 3.467483 16.279752 5.178457 +1358 43 4 0 3.010897 17.110882 3.971315 +1359 44 6 0 22.627367 7.401815 -6.857148 +1360 44 4 0 21.892213 7.078953 -7.539727 +1361 44 4 0 22.599466 6.767179 -6.162623 +1362 45 6 0 -24.350411 -14.025041 19.899958 +1363 45 4 0 -23.879390 -13.314568 19.375377 +1364 45 4 0 -25.008554 -14.400223 19.294992 +1365 46 6 0 18.357304 9.543924 6.204099 +1366 46 4 0 18.326985 9.093740 5.378574 +1367 46 4 0 19.117744 9.183856 6.709862 +1368 47 6 0 21.017970 -11.520615 -11.071883 +1369 47 4 0 21.726613 -10.894899 -10.978046 +1370 47 4 0 20.726915 -11.629983 -10.116083 +1371 48 6 0 -26.667012 4.365972 15.083664 +1372 48 4 0 -27.091443 3.550925 15.267577 +1373 48 4 0 -25.989136 4.193758 14.444620 +1374 49 6 0 12.781386 0.642540 16.526237 +1375 49 4 0 13.038723 1.476289 17.006927 +1376 49 4 0 12.089659 0.933072 15.871227 +1377 50 6 0 -27.429715 -6.725581 8.240721 +1378 50 4 0 -26.910936 -6.564480 7.470893 +1379 50 4 0 -28.162464 -7.327953 7.969065 +1380 51 6 0 24.070362 5.174514 -0.911512 +1381 51 4 0 24.629840 5.966148 -0.705486 +1382 51 4 0 23.362520 5.287238 -1.509298 +1383 52 6 0 16.846666 -16.995462 -13.603864 +1384 52 4 0 15.867560 -16.748669 -13.456021 +1385 52 4 0 17.071846 -16.254095 -14.246763 +1386 53 6 0 20.841116 12.797120 17.009497 +1387 53 4 0 20.969187 13.669803 17.421731 +1388 53 4 0 21.771225 12.416689 16.764510 +1389 54 6 0 -19.221734 -18.875573 -10.983743 +1390 54 4 0 -20.186979 -18.779925 -10.982038 +1391 54 4 0 -19.009681 -19.369621 -10.158798 +1392 55 6 0 -18.683521 -20.505972 -16.031221 +1393 55 4 0 -19.618898 -20.618800 -16.082058 +1394 55 4 0 -18.315789 -21.292104 -15.650396 +1395 56 6 0 13.486524 6.749112 5.293446 +1396 56 4 0 13.961609 6.056192 4.983058 +1397 56 4 0 12.780504 7.007906 4.716738 +1398 57 6 0 20.810382 20.409198 13.765268 +1399 57 4 0 21.268029 20.454532 14.598864 +1400 57 4 0 19.895912 20.318361 13.998352 +1401 58 6 0 20.363727 -12.785030 1.387420 +1402 58 4 0 20.625728 -12.042183 1.970150 +1403 58 4 0 19.472843 -13.114509 1.692870 +1404 59 6 0 -4.110768 13.121183 -4.644500 +1405 59 4 0 -3.600734 12.558925 -4.032909 +1406 59 4 0 -4.403120 13.867412 -4.044378 +1407 60 6 0 -21.061840 -7.740629 20.493954 +1408 60 4 0 -21.039453 -7.543946 19.536841 +1409 60 4 0 -21.757349 -7.146898 20.900973 +1410 61 6 0 26.211082 -13.851944 -14.351632 +1411 61 4 0 26.688652 -13.578058 -13.560156 +1412 61 4 0 25.237610 -13.844318 -14.168406 +1413 62 6 0 7.682001 -20.605822 4.285305 +1414 62 4 0 8.364066 -21.007718 3.810153 +1415 62 4 0 7.192709 -19.999465 3.748655 +1416 63 6 0 22.004930 15.161537 5.915259 +1417 63 4 0 22.529069 15.401145 5.140758 +1418 63 4 0 21.836857 14.241604 6.044353 +1419 64 6 0 21.713613 -17.900383 3.815703 +1420 64 4 0 22.679247 -17.725384 3.950726 +1421 64 4 0 21.695664 -18.649618 3.180406 +1422 65 6 0 11.567159 -18.128823 12.553393 +1423 65 4 0 11.856655 -17.178344 12.428270 +1424 65 4 0 11.248307 -18.230630 13.449380 +1425 66 6 0 -22.622068 18.057993 -12.095565 +1426 66 4 0 -21.694228 17.853670 -11.941877 +1427 66 4 0 -22.819172 17.835208 -12.993248 +1428 67 6 0 9.275007 12.390062 -11.584253 +1429 67 4 0 8.977379 13.016934 -10.914605 +1430 67 4 0 10.127813 12.041771 -11.232361 +1431 68 6 0 -14.822916 -15.989738 9.135198 +1432 68 4 0 -14.194812 -16.628214 9.459309 +1433 68 4 0 -14.342626 -15.188459 9.014917 +1434 69 6 0 -11.828358 -9.561319 -4.583271 +1435 69 4 0 -12.150096 -9.065398 -5.351378 +1436 69 4 0 -12.516681 -10.185548 -4.230080 +1437 70 6 0 -10.898855 6.281982 -10.651011 +1438 70 4 0 -11.533704 6.844824 -10.249357 +1439 70 4 0 -10.394778 5.928734 -9.945580 +1440 71 6 0 10.206251 18.878731 19.697794 +1441 71 4 0 10.128033 18.397864 20.526746 +1442 71 4 0 9.368907 19.321892 19.635002 +1443 72 6 0 7.056097 15.592239 15.029949 +1444 72 4 0 7.186116 15.478315 14.072096 +1445 72 4 0 7.414569 14.832987 15.435389 +1446 73 6 0 24.543977 3.489901 -14.044452 +1447 73 4 0 23.682275 3.287251 -13.651175 +1448 73 4 0 24.372867 3.165473 -14.930902 +1449 74 6 0 -0.579079 -10.101283 9.711937 +1450 74 4 0 -1.148742 -10.353328 9.005933 +1451 74 4 0 -0.914837 -9.213566 9.976954 +1452 75 6 0 6.810722 17.081705 -5.703105 +1453 75 4 0 5.903603 16.716054 -5.813888 +1454 75 4 0 7.038830 17.199405 -6.631357 +1455 76 6 0 -26.352729 7.462163 20.420411 +1456 76 4 0 -27.199047 7.711650 20.831378 +1457 76 4 0 -26.411228 7.671245 19.444854 +1458 77 6 0 17.042652 1.713603 8.364686 +1459 77 4 0 16.951087 0.795520 8.175385 +1460 77 4 0 16.736372 2.035025 7.509624 +1461 78 6 0 19.131873 19.334012 -6.335242 +1462 78 4 0 18.416265 18.729295 -6.454050 +1463 78 4 0 19.910836 18.805924 -6.078777 +1464 79 6 0 7.310440 -10.543485 13.587642 +1465 79 4 0 6.863481 -11.404338 13.838041 +1466 79 4 0 6.716557 -9.980934 13.023023 +1467 80 6 0 16.655451 5.245734 12.848556 +1468 80 4 0 17.418946 5.791006 12.911180 +1469 80 4 0 16.851104 4.455072 13.419371 +1470 81 6 0 -11.098331 12.748199 -7.329972 +1471 81 4 0 -11.009338 13.599863 -7.754046 +1472 81 4 0 -12.065844 12.538087 -7.393876 +1473 82 6 0 -12.334041 -5.457784 -13.381783 +1474 82 4 0 -12.711013 -4.568395 -13.257780 +1475 82 4 0 -11.461517 -5.234972 -13.709702 +1476 83 6 0 -19.619563 15.046747 6.026220 +1477 83 4 0 -19.064160 15.888434 5.869584 +1478 83 4 0 -20.197675 14.948767 5.270745 +1479 84 6 0 19.403362 5.853957 6.190263 +1480 84 4 0 18.497327 6.115780 6.469846 +1481 84 4 0 20.017752 6.471645 6.487352 +1482 85 6 0 -25.726372 -3.750023 6.981390 +1483 85 4 0 -26.510590 -3.855351 7.566875 +1484 85 4 0 -25.108784 -4.364237 7.293376 +1485 86 6 0 19.363936 -15.722056 8.477199 +1486 86 4 0 19.376520 -16.156352 9.371325 +1487 86 4 0 20.131991 -16.106093 8.026790 +1488 87 6 0 4.918015 16.654603 6.129016 +1489 87 4 0 5.581517 17.300026 5.845056 +1490 87 4 0 5.390842 15.802197 6.094486 +1491 88 6 0 6.078733 16.693115 -13.842069 +1492 88 4 0 5.199251 16.442614 -14.064650 +1493 88 4 0 6.443869 16.763088 -14.767416 +1494 89 6 0 21.731326 -12.551581 -19.815904 +1495 89 4 0 21.519077 -11.572592 -19.819800 +1496 89 4 0 21.264568 -12.901316 -18.987186 +1497 90 6 0 24.487045 0.545827 12.845924 +1498 90 4 0 24.038085 0.883409 12.081688 +1499 90 4 0 24.083597 0.980384 13.591108 +1500 91 6 0 18.410889 -13.655540 -1.593840 +1501 91 4 0 18.336634 -14.202424 -0.852695 +1502 91 4 0 19.187521 -13.942267 -2.059694 +1503 92 6 0 10.380738 17.460434 -20.015294 +1504 92 4 0 9.800569 16.677901 -20.098710 +1505 92 4 0 10.044263 17.935616 -19.257888 +1506 93 6 0 13.540400 13.359091 -2.277273 +1507 93 4 0 13.918768 14.199197 -2.621352 +1508 93 4 0 13.546416 13.374894 -1.268707 +1509 94 6 0 19.550822 -15.885302 -17.171256 +1510 94 4 0 19.618925 -16.577230 -17.813037 +1511 94 4 0 20.364869 -15.924821 -16.745913 +1512 95 6 0 8.934453 -16.027660 20.082161 +1513 95 4 0 8.350825 -15.432721 20.504320 +1514 95 4 0 9.504005 -15.407057 19.696244 +1515 96 6 0 13.449317 -0.696209 -11.399773 +1516 96 4 0 14.259684 -0.816041 -10.861718 +1517 96 4 0 12.841649 -1.407477 -11.030433 +1518 97 6 0 21.159598 -20.230615 11.116255 +1519 97 4 0 20.955379 -21.039069 10.677683 +1520 97 4 0 21.227629 -20.467861 12.046012 +1521 98 6 0 -11.425719 10.313603 15.561621 +1522 98 4 0 -11.752060 9.489612 15.149018 +1523 98 4 0 -12.009787 11.024201 15.339594 +1524 99 6 0 23.530234 5.073332 12.308815 +1525 99 4 0 23.411228 4.192303 12.037314 +1526 99 4 0 23.017800 5.539035 11.565588 +1527 100 6 0 9.285394 15.401019 4.247587 +1528 100 4 0 9.029223 16.111512 4.827382 +1529 100 4 0 9.908946 14.931813 4.786975 +1530 101 6 0 26.710953 10.879732 17.565984 +1531 101 4 0 26.481837 11.014223 18.458503 +1532 101 4 0 26.801930 11.751805 17.193691 +1533 102 6 0 26.059219 -18.322514 -8.230640 +1534 102 4 0 25.468209 -17.831491 -8.807599 +1535 102 4 0 26.660395 -17.588693 -7.832128 +1536 103 6 0 7.573847 10.494945 -13.000340 +1537 103 4 0 6.752773 10.585941 -12.508913 +1538 103 4 0 8.060915 11.203548 -12.596091 +1539 104 6 0 16.495334 16.907261 -17.264088 +1540 104 4 0 15.936311 17.701142 -17.215765 +1541 104 4 0 16.146725 16.404479 -17.972530 +1542 105 6 0 12.550501 12.792681 0.441559 +1543 105 4 0 12.890193 12.783948 1.424080 +1544 105 4 0 12.972043 11.976735 0.117581 +1545 106 6 0 6.804544 2.469256 9.043785 +1546 106 4 0 7.053760 2.925055 9.856512 +1547 106 4 0 7.365554 1.678918 9.065958 +1548 107 6 0 -26.111190 11.845380 12.004953 +1549 107 4 0 -26.772515 12.430684 11.621087 +1550 107 4 0 -25.209540 12.292191 11.872070 +1551 108 6 0 -10.314383 -9.317643 -12.200930 +1552 108 4 0 -11.268643 -8.984584 -12.345854 +1553 108 4 0 -10.432002 -10.035760 -11.529786 +1554 109 6 0 -26.380108 15.118882 -9.622008 +1555 109 4 0 -25.930871 15.887042 -9.924512 +1556 109 4 0 -25.979073 14.306361 -10.084998 +1557 110 6 0 1.139515 -19.714505 -8.279716 +1558 110 4 0 0.675447 -19.100241 -8.876686 +1559 110 4 0 1.861101 -19.991496 -8.757935 +1560 111 6 0 17.452914 16.822171 9.920464 +1561 111 4 0 17.934078 17.151660 9.199989 +1562 111 4 0 17.980199 16.103548 10.329451 +1563 112 6 0 18.740004 -12.107924 14.391777 +1564 112 4 0 19.596584 -12.274465 14.867937 +1565 112 4 0 18.902733 -12.244474 13.491103 +1566 113 6 0 -15.579375 6.511760 13.017065 +1567 113 4 0 -15.193219 7.321701 12.610540 +1568 113 4 0 -15.093538 5.769586 12.622079 +1569 114 6 0 -0.877815 -3.636485 14.316002 +1570 114 4 0 -1.480812 -3.188883 14.944590 +1571 114 4 0 -1.224311 -3.235271 13.526942 +1572 115 6 0 7.516564 -9.888221 20.928138 +1573 115 4 0 7.083616 -9.984725 20.119275 +1574 115 4 0 7.035439 -10.492537 21.460270 +1575 116 6 0 26.972175 15.513650 13.835965 +1576 116 4 0 27.290530 14.677325 14.220401 +1577 116 4 0 26.022826 15.628989 13.956832 +1578 117 6 0 18.373056 16.436866 -9.784173 +1579 117 4 0 18.173740 16.705423 -10.702898 +1580 117 4 0 19.003590 17.095921 -9.494087 +1581 118 6 0 -2.499599 -10.235115 -18.681799 +1582 118 4 0 -2.484635 -9.679910 -17.855014 +1583 118 4 0 -1.762196 -9.952193 -19.147621 +1584 119 6 0 2.170631 9.696760 -13.707491 +1585 119 4 0 2.410831 10.573952 -14.022044 +1586 119 4 0 1.366528 9.911718 -13.203660 +1587 120 6 0 -22.060495 0.084333 -19.330968 +1588 120 4 0 -21.759145 -0.801023 -19.628154 +1589 120 4 0 -21.345397 0.598803 -18.978005 +1590 121 6 0 20.717073 -0.364667 -3.266977 +1591 121 4 0 20.064258 -0.869174 -2.840894 +1592 121 4 0 20.978768 -0.863225 -4.123117 +1593 122 6 0 -11.693545 -17.585832 12.155919 +1594 122 4 0 -11.693581 -16.618165 12.297539 +1595 122 4 0 -10.965597 -17.630843 11.482629 +1596 123 6 0 22.033287 -5.610818 11.814279 +1597 123 4 0 21.603774 -4.969289 11.213082 +1598 123 4 0 22.863855 -5.854126 11.399621 +1599 124 6 0 -4.245364 20.530679 -11.580108 +1600 124 4 0 -4.613077 20.058542 -10.812152 +1601 124 4 0 -4.869612 21.297733 -11.750599 +1602 125 6 0 20.837886 3.849343 18.187160 +1603 125 4 0 21.637221 4.154388 17.767478 +1604 125 4 0 20.753725 4.316852 19.044680 +1605 126 6 0 4.000998 20.642070 6.993614 +1606 126 4 0 3.097228 20.600441 6.539412 +1607 126 4 0 4.007858 20.203528 7.895914 +1608 127 6 0 11.947977 15.441293 -0.469120 +1609 127 4 0 11.971275 14.454085 -0.273912 +1610 127 4 0 12.470807 15.488877 -1.291943 +1611 128 6 0 3.007637 18.543541 -2.984774 +1612 128 4 0 3.565232 17.725540 -3.038270 +1613 128 4 0 2.929337 18.913789 -3.837866 +1614 129 6 0 8.597796 -3.024177 11.307241 +1615 129 4 0 9.440361 -2.907621 10.794269 +1616 129 4 0 8.194484 -3.777321 10.948431 +1617 130 6 0 12.969092 -7.932168 -3.416690 +1618 130 4 0 12.657272 -8.671538 -3.962914 +1619 130 4 0 13.930699 -7.927015 -3.644128 +1620 131 6 0 4.690692 11.990242 6.047085 +1621 131 4 0 3.830915 11.620745 5.794047 +1622 131 4 0 5.366958 11.770788 5.369987 +1623 132 6 0 10.838100 15.915400 -16.690449 +1624 132 4 0 11.719066 16.216650 -16.583824 +1625 132 4 0 10.351788 16.668150 -17.062399 +1626 133 6 0 20.760419 3.237669 6.554876 +1627 133 4 0 20.210628 2.565167 6.189576 +1628 133 4 0 20.243367 4.047032 6.450547 +1629 134 6 0 -7.351853 -2.751166 -10.694739 +1630 134 4 0 -8.277520 -2.829710 -11.023595 +1631 134 4 0 -6.973902 -2.027001 -11.286243 +1632 135 6 0 8.338680 -14.152925 -14.216839 +1633 135 4 0 7.907963 -14.913791 -13.766433 +1634 135 4 0 9.057618 -14.554948 -14.672432 +1635 136 6 0 -21.745003 -1.600080 -8.484704 +1636 136 4 0 -22.396276 -0.906185 -8.690601 +1637 136 4 0 -21.042086 -1.417961 -9.157366 +1638 137 6 0 24.505779 -7.277316 -14.651231 +1639 137 4 0 24.835649 -6.369110 -14.893362 +1640 137 4 0 24.135101 -7.595011 -15.516575 +1641 138 6 0 13.325591 -5.149951 -6.169737 +1642 138 4 0 14.291969 -5.289577 -6.041288 +1643 138 4 0 12.813376 -5.844865 -5.785812 +1644 139 6 0 -20.933242 20.161591 -8.696079 +1645 139 4 0 -20.088965 20.396502 -9.157616 +1646 139 4 0 -21.417399 20.940524 -8.320759 +1647 140 6 0 22.832947 -8.348413 -10.288572 +1648 140 4 0 23.575495 -7.724229 -10.313126 +1649 140 4 0 23.029160 -9.044226 -9.677546 +1650 141 6 0 23.743445 2.427859 19.849750 +1651 141 4 0 24.532045 1.907225 19.711678 +1652 141 4 0 23.062926 1.994077 19.368217 +1653 142 6 0 10.589993 1.639740 20.516878 +1654 142 4 0 9.987052 1.032362 20.047348 +1655 142 4 0 10.624644 2.472330 20.027640 +1656 143 6 0 6.500815 -17.047237 7.812429 +1657 143 4 0 7.407059 -16.956263 7.440866 +1658 143 4 0 6.013508 -17.774059 7.384568 +1659 144 6 0 -0.199269 -9.380208 -16.449921 +1660 144 4 0 -0.920685 -8.715985 -16.515053 +1661 144 4 0 0.387469 -9.304809 -17.255371 +1662 145 6 0 6.245654 20.180381 -12.940075 +1663 145 4 0 5.376160 20.220616 -13.392701 +1664 145 4 0 6.857081 19.702851 -13.499407 +1665 146 6 0 -4.928957 -20.301289 11.340442 +1666 146 4 0 -4.017513 -20.158995 11.049259 +1667 146 4 0 -4.923799 -20.953195 11.990322 +1668 147 6 0 -11.515851 -8.388468 19.647979 +1669 147 4 0 -11.184791 -8.359618 20.524675 +1670 147 4 0 -12.443923 -8.327763 19.606292 +1671 148 6 0 -24.167509 7.194575 -0.837148 +1672 148 4 0 -24.972654 7.649920 -1.275517 +1673 148 4 0 -24.204709 7.474688 0.131591 +1674 149 6 0 12.126351 -16.062203 11.096539 +1675 149 4 0 11.280449 -15.927172 10.574646 +1676 149 4 0 12.611089 -15.288570 10.879908 +1677 150 6 0 -7.169287 5.827131 17.736258 +1678 150 4 0 -6.956548 5.152949 17.035326 +1679 150 4 0 -6.291387 6.127541 18.098754 +1680 151 6 0 -19.820265 12.907447 16.581358 +1681 151 4 0 -19.659011 12.980070 17.534136 +1682 151 4 0 -20.478433 13.648938 16.483830 +1683 152 6 0 10.474631 10.634400 -7.924386 +1684 152 4 0 10.794363 11.386619 -7.409132 +1685 152 4 0 9.591861 10.377005 -7.560987 +1686 153 6 0 9.869765 7.468088 9.667232 +1687 153 4 0 9.072542 8.000794 9.695304 +1688 153 4 0 10.102662 7.299293 8.720054 +1689 154 6 0 11.149756 9.562904 -12.765396 +1690 154 4 0 10.686250 9.267978 -11.959062 +1691 154 4 0 11.324858 8.766817 -13.298380 +1692 155 6 0 -8.591767 12.757143 -4.012695 +1693 155 4 0 -8.324896 13.003317 -4.932948 +1694 155 4 0 -8.147829 13.384049 -3.416515 +1695 156 6 0 4.774504 19.024876 15.999665 +1696 156 4 0 4.160294 19.017277 16.757162 +1697 156 4 0 5.517925 18.569472 16.400595 +1698 157 6 0 -4.714429 -2.091345 19.353537 +1699 157 4 0 -4.854280 -2.828837 19.971329 +1700 157 4 0 -5.535288 -2.163222 18.793806 +1701 158 6 0 3.570216 -18.611817 -15.598378 +1702 158 4 0 3.046765 -18.582990 -16.425866 +1703 158 4 0 3.158896 -17.918154 -15.032600 +1704 159 6 0 -11.657691 18.235653 20.509864 +1705 159 4 0 -12.226759 18.986315 20.717707 +1706 159 4 0 -11.080397 18.121952 21.271087 +1707 160 6 0 14.493937 -0.382813 19.719393 +1708 160 4 0 13.979118 -0.142020 20.470391 +1709 160 4 0 15.349953 -0.432678 20.118874 +1710 161 6 0 -25.714868 -12.047610 -14.994953 +1711 161 4 0 -25.527994 -12.236118 -16.000515 +1712 161 4 0 -24.876261 -11.553460 -14.748410 +1713 162 6 0 6.325847 -15.764455 11.544131 +1714 162 4 0 6.229128 -16.154079 12.417251 +1715 162 4 0 6.886521 -15.002890 11.743125 +1716 163 6 0 -27.331883 9.233246 15.237568 +1717 163 4 0 -26.599380 9.867873 14.994627 +1718 163 4 0 -27.264332 8.495991 14.623286 +1719 164 6 0 -25.207375 -3.847132 17.095096 +1720 164 4 0 -25.445321 -4.629286 16.543803 +1721 164 4 0 -25.823438 -3.158780 16.776808 +1722 165 6 0 -2.766266 -13.179260 4.266317 +1723 165 4 0 -1.896026 -13.215786 3.757612 +1724 165 4 0 -3.151612 -14.038152 4.175240 +1725 166 6 0 17.165111 16.676060 6.100929 +1726 166 4 0 17.064451 17.522432 6.606579 +1727 166 4 0 16.942925 15.940574 6.655125 +1728 167 6 0 -18.331646 7.552754 -8.484008 +1729 167 4 0 -18.933791 7.004225 -7.919061 +1730 167 4 0 -18.900890 7.785944 -9.196075 +1731 168 6 0 26.169311 3.132717 9.584634 +1732 168 4 0 26.518912 3.613350 10.302634 +1733 168 4 0 25.680453 2.435972 9.901377 +1734 169 6 0 1.192323 17.107553 -8.736586 +1735 169 4 0 1.021901 17.797734 -9.422544 +1736 169 4 0 0.892750 17.475660 -7.885822 +1737 170 6 0 -25.815030 10.180500 5.376868 +1738 170 4 0 -26.459337 10.344257 6.080597 +1739 170 4 0 -25.337134 9.352614 5.563562 +1740 171 6 0 9.219642 -20.775000 0.193729 +1741 171 4 0 9.939354 -21.194791 -0.335512 +1742 171 4 0 8.458200 -21.122557 -0.245347 +1743 172 6 0 7.419149 -15.012981 -7.052183 +1744 172 4 0 7.072086 -14.800593 -6.138570 +1745 172 4 0 6.878848 -15.717530 -7.366638 +1746 173 6 0 18.623745 10.156288 3.028217 +1747 173 4 0 17.982257 9.440233 2.875628 +1748 173 4 0 18.009023 10.975494 3.182536 +1749 174 6 0 13.145546 -20.676260 -16.694649 +1750 174 4 0 12.815312 -20.227755 -17.488442 +1751 174 4 0 12.786182 -21.555938 -16.737351 +1752 175 6 0 4.910310 -17.490236 -1.378014 +1753 175 4 0 5.657779 -17.456107 -0.820623 +1754 175 4 0 5.268563 -17.934730 -2.200934 +1755 176 6 0 -0.270185 6.286195 9.930733 +1756 176 4 0 -0.856415 6.001917 10.611025 +1757 176 4 0 0.005563 7.171058 10.176397 +1758 177 6 0 -3.229650 16.643646 19.387659 +1759 177 4 0 -3.312058 16.163949 18.538257 +1760 177 4 0 -2.782251 17.481594 19.257422 +1761 178 6 0 -16.368157 2.960013 13.098824 +1762 178 4 0 -16.360100 3.430962 13.984851 +1763 178 4 0 -16.773065 3.567928 12.508334 +1764 179 6 0 19.447080 -6.209321 9.611666 +1765 179 4 0 18.833539 -5.622887 9.193795 +1766 179 4 0 18.949525 -6.526265 10.384214 +1767 180 6 0 -8.044280 -4.288816 -16.207882 +1768 180 4 0 -7.966109 -3.883769 -17.074640 +1769 180 4 0 -7.261903 -4.793399 -15.982149 +1770 181 6 0 20.024947 17.270827 14.758218 +1771 181 4 0 19.172341 17.478642 15.170634 +1772 181 4 0 20.700921 17.006922 15.403538 +1773 182 6 0 24.735763 -12.617736 3.782055 +1774 182 4 0 24.742238 -13.518522 3.370896 +1775 182 4 0 25.350602 -12.232493 3.147824 +1776 183 6 0 3.431414 8.925671 6.826679 +1777 183 4 0 3.084862 8.827163 7.759644 +1778 183 4 0 4.424412 9.107829 6.895448 +1779 184 6 0 17.489102 -11.319977 19.702626 +1780 184 4 0 18.434347 -11.550903 19.419885 +1781 184 4 0 16.965653 -12.122535 19.583109 +1782 185 6 0 13.274816 16.183286 -2.849704 +1783 185 4 0 13.777976 16.949053 -2.573649 +1784 185 4 0 12.549844 16.546466 -3.345363 +1785 186 6 0 23.841910 -13.944818 11.597095 +1786 186 4 0 23.043336 -14.386099 11.958056 +1787 186 4 0 23.668687 -13.015455 11.845078 +1788 187 6 0 14.458157 -17.498951 -20.684884 +1789 187 4 0 13.916318 -16.687121 -20.523929 +1790 187 4 0 14.348004 -17.977683 -19.850686 +1791 188 6 0 -8.369104 15.140447 -19.622301 +1792 188 4 0 -9.156426 14.702367 -19.949175 +1793 188 4 0 -7.765440 15.416867 -20.299390 +1794 189 6 0 19.145293 -12.193056 11.874609 +1795 189 4 0 18.766654 -11.373734 11.579591 +1796 189 4 0 18.521350 -12.726230 11.327543 +1797 190 6 0 -18.076775 18.801612 -14.295021 +1798 190 4 0 -18.586562 18.486836 -15.063616 +1799 190 4 0 -18.385853 18.166574 -13.559441 +1800 191 6 0 -19.106085 17.513715 -16.406412 +1801 191 4 0 -18.423458 17.909352 -17.009956 +1802 191 4 0 -19.076533 16.547362 -16.469991 +1803 192 6 0 8.044684 -0.011875 -10.373353 +1804 192 4 0 8.668860 -0.626009 -9.915411 +1805 192 4 0 8.602268 0.704634 -10.757756 +1806 193 6 0 -23.287552 -7.074362 17.929889 +1807 193 4 0 -22.370365 -7.411352 17.793085 +1808 193 4 0 -23.082861 -6.243551 18.339191 +1809 194 6 0 22.099315 -0.856463 5.137385 +1810 194 4 0 22.143526 -1.231806 5.942781 +1811 194 4 0 22.809699 -1.264756 4.609180 +1812 195 6 0 11.618777 5.171830 -12.366225 +1813 195 4 0 12.078170 4.347700 -12.198463 +1814 195 4 0 10.837551 5.069580 -11.726531 +1815 196 6 0 13.014153 9.452672 -20.836207 +1816 196 4 0 13.647981 9.913017 -20.352836 +1817 196 4 0 13.495084 8.718233 -21.270254 +1818 197 6 0 12.425877 4.164162 0.171584 +1819 197 4 0 12.703840 3.756309 0.988868 +1820 197 4 0 12.991444 5.029213 0.073462 +1821 198 6 0 -9.835180 14.629378 -13.804396 +1822 198 4 0 -9.610077 14.944151 -14.684564 +1823 198 4 0 -8.989021 14.154277 -13.615953 +1824 199 6 0 -2.408060 19.252237 0.880939 +1825 199 4 0 -2.493340 19.315730 -0.074698 +1826 199 4 0 -2.255762 20.125803 1.185504 +1827 200 6 0 0.176360 18.576859 -11.340843 +1828 200 4 0 0.973470 18.653833 -11.875634 +1829 200 4 0 -0.251936 19.428753 -11.234458 +1830 201 6 0 17.647376 -13.725079 1.965824 +1831 201 4 0 17.003636 -13.021631 1.726278 +1832 201 4 0 17.566508 -13.822114 2.932054 +1833 202 6 0 22.517860 -11.753774 5.019726 +1834 202 4 0 23.053003 -11.763573 4.218425 +1835 202 4 0 22.141706 -12.627432 4.996598 +1836 203 6 0 11.399220 8.806142 17.642468 +1837 203 4 0 12.004399 8.181799 18.040253 +1838 203 4 0 12.065291 9.442856 17.324430 +1839 204 6 0 -22.707547 3.590100 -15.076457 +1840 204 4 0 -23.015628 3.384474 -15.944834 +1841 204 4 0 -22.136913 4.410365 -15.213029 +1842 205 6 0 26.828338 -4.765161 15.663973 +1843 205 4 0 26.832047 -4.257803 16.501858 +1844 205 4 0 26.708016 -5.703070 15.737740 +1845 206 6 0 22.946626 3.404021 -19.628978 +1846 206 4 0 23.362608 3.005393 -20.435220 +1847 206 4 0 23.702005 3.678843 -19.069388 +1848 207 6 0 14.618693 -13.688118 5.201099 +1849 207 4 0 14.145978 -13.778387 4.371412 +1850 207 4 0 14.286294 -12.904817 5.661369 +1851 208 6 0 20.255504 -4.724409 16.548573 +1852 208 4 0 21.059576 -4.438221 16.144026 +1853 208 4 0 20.147655 -4.094495 17.295647 +1854 209 6 0 17.946944 -13.347081 -18.020931 +1855 209 4 0 18.795624 -13.646112 -18.426334 +1856 209 4 0 17.332163 -14.081728 -18.189230 +1857 210 6 0 -21.344615 -17.675607 -16.681902 +1858 210 4 0 -21.267118 -18.651712 -16.747948 +1859 210 4 0 -21.006193 -17.563628 -15.786919 +1860 211 6 0 9.992481 17.630547 2.228887 +1861 211 4 0 10.766809 17.530717 1.634799 +1862 211 4 0 9.806200 16.754569 2.642189 +1863 212 6 0 24.337802 -5.112482 8.921340 +1864 212 4 0 24.079827 -4.328771 8.467115 +1865 212 4 0 24.773308 -4.851600 9.745303 +1866 213 6 0 14.392943 4.303039 -14.169804 +1867 213 4 0 15.354569 4.444986 -14.451391 +1868 213 4 0 13.827235 4.378323 -14.920116 +1869 214 6 0 13.209648 -16.451396 -6.580199 +1870 214 4 0 13.147603 -16.683269 -5.631990 +1871 214 4 0 12.554494 -16.916090 -7.141613 +1872 215 6 0 -11.258451 -8.728449 -17.504889 +1873 215 4 0 -10.630935 -8.841887 -16.742169 +1874 215 4 0 -10.880429 -7.995350 -17.987253 +1875 216 6 0 6.970091 -11.502288 7.137693 +1876 216 4 0 6.712825 -11.950891 7.959605 +1877 216 4 0 6.204207 -11.628119 6.619766 +1878 217 6 0 -10.553038 -2.495546 -20.126478 +1879 217 4 0 -11.112035 -2.806841 -20.861108 +1880 217 4 0 -10.112026 -1.746092 -20.545249 +1881 218 6 0 1.164804 16.447528 -16.932229 +1882 218 4 0 1.075245 17.028648 -17.728070 +1883 218 4 0 0.434843 16.567725 -16.272167 +1884 219 6 0 8.169876 -8.073942 10.663670 +1885 219 4 0 8.495588 -8.362155 9.831946 +1886 219 4 0 7.357988 -8.507192 10.922724 +1887 220 6 0 -9.618401 15.869865 -1.419048 +1888 220 4 0 -10.476694 15.771852 -1.849867 +1889 220 4 0 -9.747028 16.624761 -0.845144 +1890 221 6 0 -16.212359 4.292450 15.905633 +1891 221 4 0 -15.313397 4.006789 16.095169 +1892 221 4 0 -16.439629 4.732906 16.740073 +1893 222 6 0 21.084596 9.207592 -17.940912 +1894 222 4 0 20.944531 8.655711 -18.738875 +1895 222 4 0 20.567153 10.036337 -17.965821 +1896 223 6 0 6.469383 -5.770861 20.006921 +1897 223 4 0 5.993567 -6.597617 19.829705 +1898 223 4 0 7.305198 -6.017049 20.409842 +1899 224 6 0 17.758755 -18.446472 11.244435 +1900 224 4 0 16.943206 -18.055205 11.026410 +1901 224 4 0 17.620974 -18.589448 12.216673 +1902 225 6 0 2.239377 -2.639523 -18.372832 +1903 225 4 0 2.961435 -2.802836 -17.698014 +1904 225 4 0 2.575925 -2.857520 -19.307575 +1905 226 6 0 21.718884 10.313541 3.085849 +1906 226 4 0 21.842990 10.122072 2.194243 +1907 226 4 0 20.773441 10.408461 3.286860 +1908 227 6 0 13.337112 -4.261456 -15.095198 +1909 227 4 0 12.794211 -4.900007 -14.644470 +1910 227 4 0 14.199509 -4.728814 -15.315507 +1911 228 6 0 -9.310962 9.865254 8.826714 +1912 228 4 0 -9.669554 9.579689 7.984792 +1913 228 4 0 -9.735207 9.276237 9.445171 +1914 229 6 0 -15.178299 -9.566992 -12.324180 +1915 229 4 0 -15.367699 -10.462879 -12.630414 +1916 229 4 0 -14.646062 -9.588613 -11.528432 +1917 230 6 0 -15.859885 -9.750776 8.964734 +1918 230 4 0 -15.304809 -9.850444 8.125201 +1919 230 4 0 -16.789316 -9.705790 8.757985 +1920 231 6 0 -25.239908 11.310293 -1.569623 +1921 231 4 0 -25.920791 10.663431 -1.377427 +1922 231 4 0 -24.373594 10.784234 -1.594237 +1923 232 6 0 24.834518 19.880125 -12.068838 +1924 232 4 0 24.902598 19.037821 -11.641999 +1925 232 4 0 24.569359 20.529336 -11.363034 +1926 233 6 0 -4.910084 -12.441089 2.868321 +1927 233 4 0 -4.196304 -12.571833 3.512128 +1928 233 4 0 -4.472778 -12.489053 1.987214 +1929 234 6 0 26.315754 13.248691 -3.958358 +1930 234 4 0 27.266655 13.212107 -4.180929 +1931 234 4 0 26.465406 13.335958 -3.028348 +1932 235 6 0 24.328527 13.817013 16.149181 +1933 235 4 0 24.827781 14.030624 16.932358 +1934 235 4 0 24.179636 14.591188 15.603219 +1935 236 6 0 21.962373 -16.827624 8.004516 +1936 236 4 0 22.598048 -16.206072 7.580939 +1937 236 4 0 22.450590 -17.261823 8.740917 +1938 237 6 0 -4.825363 -16.614974 -12.877741 +1939 237 4 0 -4.014790 -16.722031 -13.388018 +1940 237 4 0 -4.509200 -15.980807 -12.256351 +1941 238 6 0 23.185997 6.818710 7.631707 +1942 238 4 0 24.005009 7.366044 7.817913 +1943 238 4 0 22.474898 7.499325 7.506791 +1944 239 6 0 6.937383 5.850956 20.832797 +1945 239 4 0 7.490164 6.651357 20.679338 +1946 239 4 0 6.435673 5.734889 20.013467 +1947 240 6 0 25.402656 -2.159701 -17.957744 +1948 240 4 0 25.621496 -3.084064 -17.880786 +1949 240 4 0 25.529344 -1.860574 -18.911595 +1950 241 6 0 10.846509 -11.228008 2.120758 +1951 241 4 0 9.913338 -11.028888 2.277705 +1952 241 4 0 11.049198 -10.691152 1.384887 +1953 242 6 0 23.084559 -1.383675 -1.852278 +1954 242 4 0 23.773226 -1.138388 -2.498419 +1955 242 4 0 22.268498 -0.905061 -2.136333 +1956 243 6 0 -25.783789 -13.543097 -4.342707 +1957 243 4 0 -26.780798 -13.463014 -4.533505 +1958 243 4 0 -25.653740 -14.383466 -3.955333 +1959 244 6 0 1.861632 12.171063 18.076482 +1960 244 4 0 2.556591 11.916600 18.652688 +1961 244 4 0 1.260792 12.537866 18.715290 +1962 245 6 0 -19.142537 14.105154 8.572032 +1963 245 4 0 -19.793181 13.415150 8.631452 +1964 245 4 0 -19.398536 14.384324 7.672644 +1965 246 6 0 9.479353 -2.096525 -4.320850 +1966 246 4 0 10.426570 -2.240688 -4.643403 +1967 246 4 0 9.264888 -1.350839 -4.888316 +1968 247 6 0 3.551422 -11.576062 19.271265 +1969 247 4 0 4.336383 -11.005500 19.220941 +1970 247 4 0 3.612389 -12.122719 20.093542 +1971 248 6 0 -18.654239 -9.535541 17.560019 +1972 248 4 0 -17.877715 -9.179943 17.854976 +1973 248 4 0 -18.494513 -10.119241 16.820922 +1974 249 6 0 22.066324 -17.399278 -0.499821 +1975 249 4 0 21.820234 -16.674838 0.099599 +1976 249 4 0 21.433067 -17.360481 -1.209273 +1977 250 6 0 -9.234082 15.614627 11.653381 +1978 250 4 0 -8.328429 15.947628 11.735875 +1979 250 4 0 -9.156328 14.657428 11.604942 +1980 251 6 0 22.367726 20.360775 16.024793 +1981 251 4 0 21.845316 20.438168 16.820627 +1982 251 4 0 23.011426 21.038841 16.155608 +1983 252 6 0 25.827187 -16.169219 18.903921 +1984 252 4 0 25.252638 -15.420311 18.639632 +1985 252 4 0 25.326971 -16.554629 19.621305 +1986 253 6 0 -19.668270 -7.707320 -8.620499 +1987 253 4 0 -19.491830 -6.794820 -8.636334 +1988 253 4 0 -20.495353 -7.784914 -8.110009 +1989 254 6 0 -15.712732 17.116061 17.387342 +1990 254 4 0 -14.998205 17.679818 17.573935 +1991 254 4 0 -16.301994 17.627283 16.828989 +1992 255 6 0 0.390078 14.938221 -20.122911 +1993 255 4 0 -0.551277 14.873494 -20.329275 +1994 255 4 0 0.539841 14.256395 -19.453229 +1995 256 6 0 15.977716 -18.683555 17.772786 +1996 256 4 0 15.456606 -18.921580 16.979089 +1997 256 4 0 16.280568 -17.751033 17.661557 +1998 257 6 0 5.239306 11.123091 17.557541 +1999 257 4 0 4.918202 10.242467 17.653834 +2000 257 4 0 6.086403 10.952070 18.021365 +2001 258 6 0 9.328850 -5.185156 13.272163 +2002 258 4 0 9.601653 -6.131901 13.229534 +2003 258 4 0 9.762360 -4.740121 12.531719 +2004 259 6 0 25.477790 -8.345165 0.584885 +2005 259 4 0 25.598427 -7.389198 0.879361 +2006 259 4 0 26.086040 -8.798249 1.118095 +2007 260 6 0 17.311830 -17.527015 -10.578123 +2008 260 4 0 17.719447 -16.732289 -10.965110 +2009 260 4 0 16.654082 -17.252150 -9.925765 +2010 261 6 0 -4.429164 -9.201790 -14.116626 +2011 261 4 0 -4.244658 -8.992311 -13.212737 +2012 261 4 0 -5.336375 -8.936542 -14.234036 +2013 262 6 0 2.267339 -4.673980 16.117302 +2014 262 4 0 3.232259 -4.591281 16.113612 +2015 262 4 0 1.900019 -4.413838 16.958419 +2016 263 6 0 25.781004 -8.714690 8.400591 +2017 263 4 0 24.912042 -8.751175 8.867313 +2018 263 4 0 25.752072 -9.508607 7.845086 +2019 264 6 0 24.780338 7.832712 -16.490027 +2020 264 4 0 25.553470 8.297242 -16.909830 +2021 264 4 0 24.349053 7.422109 -17.205903 +2022 265 6 0 -10.973211 -14.579748 -20.349565 +2023 265 4 0 -11.809581 -14.181319 -20.199526 +2024 265 4 0 -11.271798 -15.372634 -20.833354 +2025 266 6 0 20.831402 -9.834964 6.727716 +2026 266 4 0 21.613032 -10.442134 6.754402 +2027 266 4 0 20.647604 -9.731183 7.657599 +2028 267 6 0 0.619789 -15.810628 3.994148 +2029 267 4 0 0.887335 -16.417198 3.309856 +2030 267 4 0 1.249715 -15.910162 4.713083 +2031 268 6 0 23.689965 0.227417 -19.055575 +2032 268 4 0 23.390627 1.115135 -18.834814 +2033 268 4 0 24.618115 0.214091 -18.686279 +2034 269 6 0 -19.356143 -14.966182 6.464534 +2035 269 4 0 -18.731353 -14.875616 7.195912 +2036 269 4 0 -19.299498 -14.034705 6.108709 +2037 270 6 0 -4.810820 7.093213 18.692708 +2038 270 4 0 -4.214506 7.397678 17.991691 +2039 270 4 0 -5.304442 7.897279 18.897729 +2040 271 6 0 12.472494 14.825856 12.199392 +2041 271 4 0 11.666376 14.488038 12.655650 +2042 271 4 0 12.151762 15.361991 11.488854 +2043 272 6 0 -2.525590 -19.553036 -5.583420 +2044 272 4 0 -3.387077 -20.012041 -5.603558 +2045 272 4 0 -1.916602 -19.904101 -6.266561 +2046 273 6 0 -13.215935 11.484331 -2.785220 +2047 273 4 0 -12.887174 11.682417 -1.972234 +2048 273 4 0 -12.509591 11.786661 -3.422263 +2049 274 6 0 13.801640 -19.398163 -2.800474 +2050 274 4 0 12.819741 -19.619737 -2.646754 +2051 274 4 0 13.897982 -19.592042 -3.772199 +2052 275 6 0 -26.233001 19.527836 -20.067788 +2053 275 4 0 -25.451886 18.897692 -20.194468 +2054 275 4 0 -26.399315 19.934622 -20.917526 +2055 276 6 0 8.349896 -20.273103 -5.512912 +2056 276 4 0 8.674030 -19.375363 -5.549945 +2057 276 4 0 7.700037 -20.342277 -4.787842 +2058 277 6 0 -15.037355 -17.935516 15.211469 +2059 277 4 0 -14.146082 -18.339695 15.389947 +2060 277 4 0 -15.202223 -17.984699 14.215392 +2061 278 6 0 8.152699 -3.220333 -19.381684 +2062 278 4 0 7.762730 -2.473688 -19.830286 +2063 278 4 0 8.435795 -2.793242 -18.522747 +2064 279 6 0 10.849575 20.172811 -12.945894 +2065 279 4 0 9.989543 19.760584 -12.890237 +2066 279 4 0 10.974253 20.477018 -13.831243 +2067 280 6 0 -18.094216 -18.088456 -0.091619 +2068 280 4 0 -17.380813 -18.647373 0.106032 +2069 280 4 0 -18.936664 -18.511988 -0.052421 +2070 281 6 0 23.784383 -1.234714 -8.545459 +2071 281 4 0 23.004694 -0.954068 -8.088149 +2072 281 4 0 23.886388 -2.202962 -8.397824 +2073 282 6 0 4.670856 19.296845 -6.507264 +2074 282 4 0 5.525567 19.132893 -6.020467 +2075 282 4 0 4.474979 18.536310 -7.056492 +2076 283 6 0 9.453183 -16.128245 10.894262 +2077 283 4 0 9.172486 -17.052303 10.804233 +2078 283 4 0 8.694890 -15.636054 10.554101 +2079 284 6 0 27.285633 -19.419687 13.608447 +2080 284 4 0 27.147712 -20.155434 14.224268 +2081 284 4 0 27.432376 -19.841205 12.735609 +2082 285 6 0 -13.953143 18.767914 -18.628277 +2083 285 4 0 -14.509541 18.177509 -19.151919 +2084 285 4 0 -14.459773 19.481659 -18.276757 +2085 286 6 0 -8.503297 -13.558947 20.139036 +2086 286 4 0 -9.241112 -13.897460 20.705789 +2087 286 4 0 -7.777412 -13.533354 20.859006 +2088 287 6 0 14.842167 15.398345 -11.842827 +2089 287 4 0 14.711447 15.430309 -12.769279 +2090 287 4 0 14.422321 14.556870 -11.583006 +2091 288 6 0 23.515535 -17.148566 -6.707313 +2092 288 4 0 22.824916 -16.517939 -6.421660 +2093 288 4 0 24.263955 -17.052636 -6.082683 +2094 289 6 0 19.904467 -17.703379 -13.473161 +2095 289 4 0 20.119864 -16.820025 -13.921272 +2096 289 4 0 18.948028 -17.662123 -13.295016 +2097 290 6 0 -9.019729 7.630624 20.233912 +2098 290 4 0 -8.958585 7.872806 21.205680 +2099 290 4 0 -8.777610 8.395080 19.734355 +2100 291 6 0 -16.953402 12.468570 8.282984 +2101 291 4 0 -17.680339 13.160784 8.478943 +2102 291 4 0 -17.500933 11.923064 7.633961 +2103 292 6 0 -8.054795 18.180983 8.459840 +2104 292 4 0 -8.807469 17.559774 8.499933 +2105 292 4 0 -7.598916 17.959389 7.659706 +2106 293 6 0 10.859202 13.972660 9.371520 +2107 293 4 0 10.330904 14.662590 8.917941 +2108 293 4 0 11.760678 13.901317 8.995461 +2109 294 6 0 -20.599796 5.434907 14.082586 +2110 294 4 0 -19.823357 5.807091 13.669543 +2111 294 4 0 -20.650272 4.587948 13.614754 +2112 295 6 0 0.190160 0.223418 -18.957409 +2113 295 4 0 0.213080 -0.260216 -19.803123 +2114 295 4 0 -0.108015 1.088627 -19.162666 +2115 296 6 0 -14.055059 -11.353804 -4.019394 +2116 296 4 0 -14.940567 -11.063742 -3.674139 +2117 296 4 0 -13.870222 -12.125592 -3.430663 +2118 297 6 0 16.635849 17.308753 12.681784 +2119 297 4 0 16.261670 16.470264 12.423079 +2120 297 4 0 17.008841 17.677123 11.849363 +2121 298 6 0 -25.308969 5.432856 -17.149527 +2122 298 4 0 -24.655164 5.918154 -17.671798 +2123 298 4 0 -24.982451 5.555957 -16.246756 +2124 299 6 0 -5.099798 0.287541 -14.704188 +2125 299 4 0 -5.138931 0.519591 -15.635776 +2126 299 4 0 -4.195405 -0.084328 -14.624163 +2127 300 6 0 -23.748764 -10.173408 15.212702 +2128 300 4 0 -23.345980 -11.023651 15.356645 +2129 300 4 0 -22.994745 -9.539993 15.112815 +2130 301 6 0 -19.199669 -17.758897 16.946421 +2131 301 4 0 -19.316903 -16.926776 16.445483 +2132 301 4 0 -18.281115 -18.078783 16.752689 +2133 302 6 0 24.275104 4.639677 -5.172613 +2134 302 4 0 24.760810 5.226861 -4.613774 +2135 302 4 0 24.701632 4.684738 -6.052735 +2136 303 6 0 17.563599 12.903092 3.658695 +2137 303 4 0 17.685848 13.560550 2.940588 +2138 303 4 0 16.898391 13.306778 4.183635 +2139 304 6 0 4.174461 14.293392 18.270873 +2140 304 4 0 4.252009 13.308189 18.184247 +2141 304 4 0 3.284820 14.507614 18.560426 +2142 305 6 0 19.179266 -5.054347 -19.519249 +2143 305 4 0 18.780260 -5.604062 -18.845970 +2144 305 4 0 19.534147 -5.684633 -20.141388 +2145 306 6 0 15.658994 11.957779 13.199900 +2146 306 4 0 15.623319 12.838749 12.752640 +2147 306 4 0 16.531973 11.890366 13.660327 +2148 307 6 0 24.758272 -19.997077 5.366209 +2149 307 4 0 24.975628 -20.215262 6.282332 +2150 307 4 0 23.761106 -19.988430 5.431807 +2151 308 6 0 -2.249027 18.570837 -6.683241 +2152 308 4 0 -2.430859 18.100958 -7.499568 +2153 308 4 0 -2.994327 18.644727 -6.092295 +2154 309 6 0 3.560378 -14.631233 -16.617924 +2155 309 4 0 3.964695 -14.691511 -15.761000 +2156 309 4 0 3.979389 -13.913756 -17.067597 +2157 310 6 0 -20.545154 -8.912553 -11.230039 +2158 310 4 0 -21.471069 -9.085454 -11.070560 +2159 310 4 0 -20.109583 -8.288894 -10.586743 +2160 311 6 0 -19.728929 -18.157363 9.832477 +2161 311 4 0 -20.527618 -17.995705 9.320962 +2162 311 4 0 -19.366046 -18.994557 9.552804 +2163 312 6 0 -12.565736 15.723300 8.977635 +2164 312 4 0 -13.331978 15.327968 8.600724 +2165 312 4 0 -12.885953 15.953376 9.855856 +2166 313 6 0 7.768656 -13.056656 -8.955241 +2167 313 4 0 8.048624 -13.789739 -8.425150 +2168 313 4 0 8.500788 -12.860524 -9.542256 +2169 314 6 0 17.695317 -0.658526 -5.443674 +2170 314 4 0 16.888949 -0.180431 -5.230393 +2171 314 4 0 17.868907 -0.568768 -6.336008 +2172 315 6 0 -26.474265 -17.668366 15.551800 +2173 315 4 0 -25.973432 -16.911585 15.255881 +2174 315 4 0 -26.867392 -18.124201 14.764520 +2175 316 6 0 20.955024 16.299890 1.156790 +2176 316 4 0 20.921523 15.384753 1.335509 +2177 316 4 0 20.079452 16.568627 1.085050 +2178 317 6 0 -23.821616 -1.174086 5.308601 +2179 317 4 0 -24.669920 -1.473611 4.967755 +2180 317 4 0 -23.878862 -0.261519 5.469448 +2181 318 6 0 -25.063965 -17.135593 -5.451522 +2182 318 4 0 -24.564833 -16.443850 -5.938694 +2183 318 4 0 -25.016214 -17.933665 -5.953179 +2184 319 6 0 8.668628 -10.867057 3.901078 +2185 319 4 0 7.746163 -11.110803 3.959883 +2186 319 4 0 8.752868 -10.022287 4.307352 +2187 320 6 0 5.527084 -9.208555 11.411321 +2188 320 4 0 4.725607 -8.751662 11.714973 +2189 320 4 0 5.164735 -10.130404 11.316322 +2190 321 6 0 -9.337532 -6.457757 20.443267 +2191 321 4 0 -9.836709 -6.506988 19.607051 +2192 321 4 0 -8.808476 -7.295450 20.450087 +2193 322 6 0 19.513522 2.780765 9.780761 +2194 322 4 0 19.329574 3.702885 9.602934 +2195 322 4 0 18.756331 2.266956 9.355945 +2196 323 6 0 -0.037870 9.082570 10.914997 +2197 323 4 0 -0.144923 8.896093 11.865591 +2198 323 4 0 0.659909 9.734037 10.785946 +2199 324 6 0 21.027998 -15.348739 14.790857 +2200 324 4 0 21.254465 -15.801776 13.888722 +2201 324 4 0 20.075738 -15.400354 14.845656 +2202 325 6 0 14.156515 -11.391327 -14.361896 +2203 325 4 0 14.547773 -11.645291 -13.478079 +2204 325 4 0 14.944302 -11.067054 -14.899771 +2205 326 6 0 -25.175320 17.336673 -10.823444 +2206 326 4 0 -24.334636 17.464575 -11.235937 +2207 326 4 0 -25.742033 18.106292 -10.995823 +2208 327 6 0 -4.110604 17.298456 -14.084863 +2209 327 4 0 -5.063030 17.631527 -14.014860 +2210 327 4 0 -3.534872 17.849349 -13.549744 +2211 328 6 0 -8.725501 -4.824788 13.985429 +2212 328 4 0 -8.885224 -4.493817 14.844915 +2213 328 4 0 -9.307957 -4.341036 13.364528 +2214 329 6 0 -16.804142 -4.642352 -8.769233 +2215 329 4 0 -16.450670 -4.499749 -7.869595 +2216 329 4 0 -16.368056 -3.963859 -9.273107 +2217 330 6 0 -13.154274 13.347332 -10.792162 +2218 330 4 0 -13.404917 13.942330 -10.034598 +2219 330 4 0 -12.589084 12.641097 -10.473229 +2220 331 6 0 -8.087285 12.645852 17.838668 +2221 331 4 0 -8.371003 13.597239 17.804934 +2222 331 4 0 -8.469236 12.290110 16.988633 +2223 332 6 0 -22.931798 10.095495 10.652715 +2224 332 4 0 -23.213802 9.766315 11.531742 +2225 332 4 0 -23.320207 11.046413 10.700380 +2226 333 6 0 -20.983751 11.377312 6.751864 +2227 333 4 0 -21.503099 10.599928 6.692621 +2228 333 4 0 -21.162587 11.703483 7.660694 +2229 334 6 0 -9.661190 -11.046578 19.483449 +2230 334 4 0 -9.724620 -11.203957 20.428241 +2231 334 4 0 -9.182029 -11.809683 19.119545 +2232 335 6 0 20.353500 0.575918 7.152755 +2233 335 4 0 20.303576 0.620770 8.117649 +2234 335 4 0 20.337320 -0.339163 6.903512 +2235 336 6 0 15.990143 -2.457675 4.143017 +2236 336 4 0 15.489807 -1.953955 3.480334 +2237 336 4 0 15.653499 -2.040453 4.954556 +2238 337 6 0 -2.567783 16.482281 -16.807948 +2239 337 4 0 -3.050946 16.892783 -16.078496 +2240 337 4 0 -2.535318 17.087619 -17.572948 +2241 338 6 0 -16.459463 12.994478 3.247220 +2242 338 4 0 -16.263104 13.723100 3.963882 +2243 338 4 0 -16.915538 12.273221 3.618885 +2244 339 6 0 -19.849611 -12.213163 -10.741659 +2245 339 4 0 -19.664050 -11.750480 -11.517833 +2246 339 4 0 -20.220973 -11.559473 -10.070660 +2247 340 6 0 9.529408 -8.147204 4.860752 +2248 340 4 0 9.247691 -7.588893 5.626073 +2249 340 4 0 10.362750 -8.519549 5.100951 +2250 341 6 0 21.538384 -19.843213 20.537686 +2251 341 4 0 20.838857 -19.226662 20.298246 +2252 341 4 0 21.322950 -20.195215 21.445033 +2253 342 6 0 -17.414751 11.192172 -0.613866 +2254 342 4 0 -16.961551 11.804357 -1.153593 +2255 342 4 0 -16.725569 10.585952 -0.366735 +2256 343 6 0 -21.091905 1.428060 -3.164120 +2257 343 4 0 -21.397983 0.608166 -3.585164 +2258 343 4 0 -21.036566 1.285518 -2.209763 +2259 344 6 0 4.570809 -15.227797 -13.905090 +2260 344 4 0 5.091400 -16.090349 -13.835376 +2261 344 4 0 4.857834 -14.567263 -13.304845 +2262 345 6 0 10.258640 0.903759 11.623534 +2263 345 4 0 10.598017 1.120991 12.514742 +2264 345 4 0 10.521679 1.552470 11.006853 +2265 346 6 0 17.642778 19.808652 2.346246 +2266 346 4 0 17.869355 20.445525 1.653123 +2267 346 4 0 18.518553 19.467904 2.662406 +2268 347 6 0 -22.563090 -16.244370 16.474521 +2269 347 4 0 -22.037402 -15.816362 17.175370 +2270 347 4 0 -22.163193 -17.008155 16.111897 +2271 348 6 0 -21.737447 10.632642 0.323883 +2272 348 4 0 -22.138870 9.972645 -0.310600 +2273 348 4 0 -20.878663 10.242561 0.662313 +2274 349 6 0 4.943953 4.514136 10.142833 +2275 349 4 0 4.093975 4.955485 10.181030 +2276 349 4 0 5.290181 4.560969 11.077254 +2277 350 6 0 27.098096 16.972617 9.553607 +2278 350 4 0 27.164532 17.549674 10.320006 +2279 350 4 0 26.222145 17.230319 9.158216 +2280 351 6 0 9.975471 10.519219 19.375075 +2281 351 4 0 10.438521 9.921274 18.809666 +2282 351 4 0 10.113621 10.195006 20.328269 +2283 352 6 0 19.572560 8.531305 -14.059063 +2284 352 4 0 20.062311 8.733262 -13.213496 +2285 352 4 0 20.153062 7.889577 -14.538183 +2286 353 6 0 -7.918488 -2.954663 -18.780336 +2287 353 4 0 -7.314540 -2.910798 -19.514402 +2288 353 4 0 -8.797924 -3.116600 -19.166228 +2289 354 6 0 19.686374 -16.545236 11.269807 +2290 354 4 0 18.989129 -17.260241 11.377153 +2291 354 4 0 19.219253 -15.710481 11.534976 +2292 355 6 0 27.391573 13.462198 15.739536 +2293 355 4 0 26.622656 13.814429 16.131734 +2294 355 4 0 28.086271 13.184682 16.372753 +2295 356 6 0 18.671829 14.132646 1.432787 +2296 356 4 0 18.377115 15.035385 1.296775 +2297 356 4 0 19.190360 13.851325 0.615983 +2298 357 6 0 -12.681771 -19.875375 -9.428073 +2299 357 4 0 -12.883609 -20.344329 -8.608964 +2300 357 4 0 -13.567320 -19.451635 -9.646126 +2301 358 6 0 10.029899 9.448526 2.506329 +2302 358 4 0 9.228082 9.803143 2.872633 +2303 358 4 0 10.370666 8.711255 3.072050 +2304 359 6 0 6.829895 1.451627 -19.901465 +2305 359 4 0 5.933644 1.521889 -20.328666 +2306 359 4 0 6.997933 0.508973 -20.108952 +2307 360 6 0 11.280235 -14.880225 18.973288 +2308 360 4 0 11.853282 -14.806884 19.759711 +2309 360 4 0 11.206610 -13.922929 18.647648 +2310 361 6 0 -13.509311 20.508361 -14.696662 +2311 361 4 0 -13.366236 21.153458 -13.979706 +2312 361 4 0 -13.642549 19.724179 -14.192639 +2313 362 6 0 15.445671 -17.794973 -8.479139 +2314 362 4 0 14.669400 -17.783629 -7.901271 +2315 362 4 0 15.605108 -18.746647 -8.547881 +2316 363 6 0 -18.852558 16.377330 10.008262 +2317 363 4 0 -18.954566 15.472318 9.697097 +2318 363 4 0 -18.836824 16.305839 10.975588 +2319 364 6 0 -3.265075 16.259228 2.098989 +2320 364 4 0 -3.687496 16.647682 2.840607 +2321 364 4 0 -3.231168 15.327934 2.400445 +2322 365 6 0 23.408970 8.557256 -2.138126 +2323 365 4 0 23.726381 8.828223 -3.046334 +2324 365 4 0 24.153951 8.006209 -1.806696 +2325 366 6 0 -18.228938 -7.461297 -20.804424 +2326 366 4 0 -17.795687 -7.325321 -21.656583 +2327 366 4 0 -19.188295 -7.558977 -20.991723 +2328 367 6 0 14.146043 8.886880 -14.615085 +2329 367 4 0 13.553393 8.171127 -14.600739 +2330 367 4 0 15.003303 8.599303 -14.311172 +2331 368 6 0 20.665164 -4.419654 -16.715421 +2332 368 4 0 20.745422 -5.254288 -17.245683 +2333 368 4 0 20.538188 -3.785743 -17.440686 +2334 369 6 0 -26.165001 -17.430791 -11.871737 +2335 369 4 0 -26.769662 -17.569088 -12.614295 +2336 369 4 0 -25.372303 -17.816712 -12.251152 +2337 370 6 0 8.380243 12.002311 -18.225092 +2338 370 4 0 9.331509 12.039099 -17.900481 +2339 370 4 0 7.935426 11.441291 -17.531137 +2340 371 6 0 16.095732 -15.248679 -18.961804 +2341 371 4 0 16.404115 -16.023436 -19.441838 +2342 371 4 0 15.279718 -15.501183 -18.509138 +2343 372 6 0 22.345963 -0.521889 9.487232 +2344 372 4 0 22.570555 0.299269 9.062706 +2345 372 4 0 21.500534 -0.394595 9.878388 +2346 373 6 0 -5.612444 19.185073 -9.536350 +2347 373 4 0 -5.038468 18.530538 -9.043403 +2348 373 4 0 -6.014867 19.664271 -8.828529 +2349 374 6 0 -25.317965 -13.476019 -10.680751 +2350 374 4 0 -24.422815 -13.795959 -10.857483 +2351 374 4 0 -25.587407 -14.286723 -10.139795 +2352 375 6 0 5.097575 -2.791870 -18.340648 +2353 375 4 0 5.426002 -3.124971 -17.421700 +2354 375 4 0 5.173769 -1.845992 -18.214725 +2355 376 6 0 -12.050426 13.594034 -0.308748 +2356 376 4 0 -12.143354 14.332220 -0.865135 +2357 376 4 0 -12.835416 13.379684 0.170780 +2358 377 6 0 21.220086 12.431770 7.373850 +2359 377 4 0 20.289621 12.356271 7.355050 +2360 377 4 0 21.528409 11.600369 6.969319 +2361 378 6 0 -11.849558 -15.011079 -4.217755 +2362 378 4 0 -12.535045 -15.564610 -4.601476 +2363 378 4 0 -11.261594 -15.726054 -3.732481 +2364 379 6 0 19.540600 10.648547 -0.222993 +2365 379 4 0 19.073765 10.676651 0.596923 +2366 379 4 0 19.853650 11.516176 -0.351029 +2367 380 6 0 -1.367659 10.060973 3.255905 +2368 380 4 0 -0.787645 10.846481 3.221548 +2369 380 4 0 -0.921325 9.404127 2.683633 +2370 381 6 0 17.574245 20.192556 -13.486878 +2371 381 4 0 18.041333 19.630746 -14.072375 +2372 381 4 0 18.127340 20.293838 -12.705179 +2373 382 6 0 -18.105957 7.325844 1.685035 +2374 382 4 0 -17.284929 7.597738 2.015915 +2375 382 4 0 -18.515197 8.193099 1.440712 +2376 383 6 0 -25.771851 -0.494052 1.833459 +2377 383 4 0 -26.562791 0.014660 2.156519 +2378 383 4 0 -25.800109 -0.615443 0.880744 +2379 384 6 0 13.515684 3.091718 8.129575 +2380 384 4 0 12.824035 3.780462 8.011639 +2381 384 4 0 13.855067 3.149101 9.026041 +2382 385 6 0 15.024255 -12.331971 18.507086 +2383 385 4 0 14.688886 -12.986046 17.868523 +2384 385 4 0 14.285850 -11.759175 18.796860 +2385 386 6 0 10.503062 -17.208661 -17.537094 +2386 386 4 0 10.869560 -17.224545 -18.470986 +2387 386 4 0 10.144441 -18.040582 -17.343990 +2388 387 6 0 2.330431 13.849933 -16.758821 +2389 387 4 0 1.519885 13.548197 -17.169816 +2390 387 4 0 2.257199 14.793756 -16.760513 +2391 388 6 0 -23.129172 -9.148548 -12.092521 +2392 388 4 0 -24.075243 -8.995756 -12.000743 +2393 388 4 0 -23.086180 -10.039746 -12.445685 +2394 389 6 0 -17.448662 -1.079141 -7.931513 +2395 389 4 0 -17.738453 -1.885709 -7.374659 +2396 389 4 0 -18.172042 -1.099635 -8.625421 +2397 390 6 0 24.048570 -3.763661 -7.564125 +2398 390 4 0 24.193240 -3.884883 -6.642519 +2399 390 4 0 24.456227 -4.566888 -7.925689 +2400 391 6 0 -17.808703 -19.337398 7.373130 +2401 391 4 0 -17.303175 -20.173651 7.501985 +2402 391 4 0 -17.692612 -19.135904 6.461238 +2403 392 6 0 4.319079 -18.666468 -6.315988 +2404 392 4 0 4.318654 -19.531271 -6.749054 +2405 392 4 0 3.377567 -18.420225 -6.140192 +2406 393 6 0 15.744362 14.892988 2.660633 +2407 393 4 0 15.944482 15.856708 2.714939 +2408 393 4 0 15.301384 14.836913 1.848608 +2409 394 6 0 -6.829329 -18.727707 2.030136 +2410 394 4 0 -6.415578 -18.452019 2.842593 +2411 394 4 0 -6.067476 -19.005491 1.466821 +2412 395 6 0 24.121188 19.977112 -20.354495 +2413 395 4 0 24.224055 19.319758 -19.652345 +2414 395 4 0 24.762727 19.635175 -20.939363 +2415 396 6 0 10.579259 -12.534608 5.151755 +2416 396 4 0 9.930043 -12.025918 4.646940 +2417 396 4 0 11.359927 -12.071097 4.861131 +2418 397 6 0 5.967673 -14.216687 -10.676351 +2419 397 4 0 6.631855 -14.774737 -11.170158 +2420 397 4 0 6.490580 -13.637897 -10.118514 +2421 398 6 0 18.539687 -16.102929 15.331204 +2422 398 4 0 18.327655 -16.200138 16.203787 +2423 398 4 0 17.897003 -15.568195 14.864351 +2424 399 6 0 -2.895055 -4.676531 11.113797 +2425 399 4 0 -2.434824 -5.435723 10.710060 +2426 399 4 0 -2.231401 -4.035506 11.395814 +2427 400 6 0 -8.133832 14.629593 7.309404 +2428 400 4 0 -8.851831 15.090624 7.871798 +2429 400 4 0 -7.946895 13.906109 7.942402 +2430 401 6 0 22.250798 0.698906 -0.231699 +2431 401 4 0 22.200775 1.664146 -0.197509 +2432 401 4 0 22.955911 0.389699 -0.887067 +2433 402 6 0 4.057613 14.734523 9.271521 +2434 402 4 0 3.560432 15.591515 9.153949 +2435 402 4 0 4.938114 14.882755 8.921185 +2436 403 6 0 -17.698257 12.666615 -4.894250 +2437 403 4 0 -17.252884 12.676027 -4.012690 +2438 403 4 0 -18.619276 12.371224 -4.622833 +2439 404 6 0 26.668158 -12.819700 -1.311515 +2440 404 4 0 27.032009 -13.646800 -1.097954 +2441 404 4 0 26.646890 -12.850693 -2.254784 +2442 405 6 0 7.224554 13.850996 3.318452 +2443 405 4 0 8.019795 14.275937 3.600876 +2444 405 4 0 7.668540 12.980654 3.041459 +2445 406 6 0 8.952709 -7.047293 -13.075849 +2446 406 4 0 9.898167 -6.904505 -13.302591 +2447 406 4 0 8.562667 -6.214154 -12.992709 +2448 407 6 0 -17.814401 -1.840934 -1.803929 +2449 407 4 0 -18.744975 -1.741200 -1.902642 +2450 407 4 0 -17.699335 -2.395812 -1.018915 +2451 408 6 0 -24.621095 6.164997 -14.673611 +2452 408 4 0 -24.877382 5.755063 -13.785112 +2453 408 4 0 -23.950276 6.830635 -14.339769 +2454 409 6 0 10.479140 -19.025039 18.297194 +2455 409 4 0 11.349364 -18.876899 18.653004 +2456 409 4 0 10.644550 -19.606803 17.504887 +2457 410 6 0 -19.101403 14.252398 -1.786055 +2458 410 4 0 -19.573879 14.657593 -2.525389 +2459 410 4 0 -19.587903 13.601901 -1.323620 +2460 411 6 0 6.717226 1.088539 17.700070 +2461 411 4 0 6.231555 1.199419 18.516697 +2462 411 4 0 6.881490 0.099135 17.787770 +2463 412 6 0 -13.643189 -7.863866 -8.730575 +2464 412 4 0 -14.517866 -7.638837 -9.023604 +2465 412 4 0 -13.154332 -7.346815 -9.390510 +2466 413 6 0 -17.730487 0.990816 -0.622980 +2467 413 4 0 -17.303015 0.205330 -0.935730 +2468 413 4 0 -17.531444 1.017418 0.308170 +2469 414 6 0 25.260176 -10.957318 6.206094 +2470 414 4 0 25.876991 -10.477352 5.676397 +2471 414 4 0 24.475935 -10.963099 5.603334 +2472 415 6 0 14.205628 -17.408033 -13.601399 +2473 415 4 0 14.188193 -18.247713 -13.204445 +2474 415 4 0 13.713279 -17.625825 -14.405922 +2475 416 6 0 -20.784853 -15.686238 -5.898849 +2476 416 4 0 -19.875611 -15.547599 -5.727799 +2477 416 4 0 -21.245430 -14.929289 -5.375604 +2478 417 6 0 -22.633197 8.330983 -13.909999 +2479 417 4 0 -22.233520 9.245054 -13.847024 +2480 417 4 0 -21.843881 7.942242 -14.256165 +2481 418 6 0 11.786714 0.286536 -14.937634 +2482 418 4 0 11.786532 -0.671475 -15.215390 +2483 418 4 0 11.605445 0.272418 -13.981805 +2484 419 6 0 1.681240 0.254113 10.330852 +2485 419 4 0 1.597166 -0.618385 10.733271 +2486 419 4 0 1.413887 0.849687 11.007136 +2487 420 6 0 6.751727 13.837704 8.238736 +2488 420 4 0 6.439245 13.979946 7.299037 +2489 420 4 0 7.165300 14.697405 8.431164 +2490 421 6 0 22.234756 20.556412 6.164713 +2491 421 4 0 21.672715 21.351790 6.258812 +2492 421 4 0 21.702890 19.818097 6.555926 +2493 422 6 0 17.385018 20.449668 10.876882 +2494 422 4 0 16.551469 20.156010 10.407413 +2495 422 4 0 17.440995 21.384757 10.538556 +2496 423 6 0 17.700641 4.527370 19.573010 +2497 423 4 0 17.031995 4.431285 20.256942 +2498 423 4 0 17.481318 3.724034 19.023628 +2499 424 6 0 0.483339 18.111382 -1.823860 +2500 424 4 0 0.218803 18.655109 -1.106869 +2501 424 4 0 1.294713 18.496788 -2.211913 +2502 425 6 0 22.943918 -17.096855 -14.079609 +2503 425 4 0 22.830905 -16.325512 -14.742916 +2504 425 4 0 22.793828 -16.695124 -13.249381 +2505 426 6 0 -12.197414 -2.755310 -15.143763 +2506 426 4 0 -11.972492 -3.409760 -15.785801 +2507 426 4 0 -11.687560 -1.995802 -15.449188 +2508 427 6 0 26.233813 3.059744 -20.109192 +2509 427 4 0 25.634066 3.752709 -19.758728 +2510 427 4 0 26.841050 3.505495 -20.746283 +2511 428 6 0 -0.398685 9.886291 -12.320899 +2512 428 4 0 -0.971500 9.110158 -12.271110 +2513 428 4 0 -0.140227 10.055684 -11.384852 +2514 429 6 0 24.766172 -8.159537 20.532359 +2515 429 4 0 24.676407 -7.239089 20.840721 +2516 429 4 0 23.932220 -8.459730 20.138818 +2517 430 6 0 -13.286555 16.304911 0.900630 +2518 430 4 0 -13.716595 15.953327 1.640887 +2519 430 4 0 -12.366691 16.365858 1.124146 +2520 431 6 0 23.399832 -13.989313 -14.426821 +2521 431 4 0 22.828210 -13.569339 -13.765880 +2522 431 4 0 23.255649 -13.414985 -15.246789 +2523 432 6 0 -22.204092 -4.611638 18.736383 +2524 432 4 0 -21.249902 -4.938147 18.770328 +2525 432 4 0 -22.211606 -3.716829 18.428273 +2526 433 6 0 21.224851 -14.221140 4.789172 +2527 433 4 0 20.596044 -14.495409 5.464993 +2528 433 4 0 21.036876 -14.781346 3.969428 +2529 434 6 0 -0.044311 17.960476 1.830489 +2530 434 4 0 -0.313520 17.147157 1.446425 +2531 434 4 0 -0.796207 18.542831 1.866711 +2532 435 6 0 -18.246500 10.701990 6.592891 +2533 435 4 0 -19.216406 10.992455 6.669125 +2534 435 4 0 -18.267435 9.771442 6.876019 +2535 436 6 0 -0.694143 4.494214 14.021020 +2536 436 4 0 -1.277964 4.997681 13.392435 +2537 436 4 0 -1.155981 4.663647 14.857205 +2538 437 6 0 22.107052 12.819546 -9.903327 +2539 437 4 0 21.296704 13.306649 -9.951121 +2540 437 4 0 22.688713 13.295428 -10.537192 +2541 438 6 0 15.302055 -5.253465 4.034438 +2542 438 4 0 15.326181 -4.291521 3.882146 +2543 438 4 0 16.042293 -5.540500 3.526531 +2544 439 6 0 23.950953 1.271229 5.710913 +2545 439 4 0 23.173495 0.716989 5.765239 +2546 439 4 0 24.051944 1.770274 6.552925 +2547 440 6 0 14.279151 12.647971 15.806599 +2548 440 4 0 14.591090 12.573140 14.893038 +2549 440 4 0 13.381765 12.300162 15.960467 +2550 441 6 0 15.038801 -1.661905 6.589100 +2551 441 4 0 15.892587 -1.551660 6.975739 +2552 441 4 0 14.462182 -0.875051 6.734929 +2553 442 6 0 -6.429505 -9.279231 12.087220 +2554 442 4 0 -6.701830 -10.093703 11.622225 +2555 442 4 0 -5.612815 -9.032770 11.586921 +2556 443 6 0 11.290924 -10.372276 7.217133 +2557 443 4 0 10.622389 -10.955150 6.788259 +2558 443 4 0 11.616275 -9.796597 6.503882 +2559 444 6 0 -24.866907 -13.913179 10.222650 +2560 444 4 0 -24.271979 -13.182736 9.950447 +2561 444 4 0 -25.017302 -14.420326 9.408453 +2562 445 6 0 -27.314146 -19.793576 17.380891 +2563 445 4 0 -27.699149 -20.386657 16.714229 +2564 445 4 0 -26.959051 -19.085769 16.826343 +2565 446 6 0 12.965414 4.595141 18.162499 +2566 446 4 0 13.458928 3.797998 18.472673 +2567 446 4 0 12.462784 4.369395 17.349650 +2568 447 6 0 19.720286 6.716538 19.074363 +2569 447 4 0 18.977040 6.161032 19.255447 +2570 447 4 0 20.199596 6.784088 19.921433 +2571 448 6 0 -17.837323 -10.531279 11.466891 +2572 448 4 0 -18.443320 -10.286485 12.180075 +2573 448 4 0 -17.136906 -10.892709 12.057832 +2574 449 6 0 3.118617 16.201513 -14.560896 +2575 449 4 0 2.524275 15.456086 -14.261283 +2576 449 4 0 3.153477 16.211998 -15.545130 +2577 450 6 0 15.713269 9.977240 -3.550942 +2578 450 4 0 16.125798 10.839790 -3.855082 +2579 450 4 0 16.256998 9.663172 -2.774134 +2580 451 6 0 13.404328 14.288352 8.236302 +2581 451 4 0 13.804031 15.222512 8.339581 +2582 451 4 0 14.094703 13.583706 8.316160 +2583 452 6 0 1.715242 -17.595877 -5.517990 +2584 452 4 0 1.864739 -16.803207 -5.011472 +2585 452 4 0 1.121502 -17.292257 -6.152942 +2586 453 6 0 11.186181 -15.378074 -8.941210 +2587 453 4 0 10.964916 -15.109818 -9.814041 +2588 453 4 0 11.164732 -14.643976 -8.304569 +2589 454 6 0 -25.412651 0.765668 -5.618949 +2590 454 4 0 -25.840497 0.596705 -6.434188 +2591 454 4 0 -26.027451 1.074079 -4.940438 +2592 455 6 0 -11.380143 13.107124 -18.001950 +2593 455 4 0 -12.159770 13.386797 -17.518060 +2594 455 4 0 -11.627822 13.258638 -18.958908 +2595 456 6 0 7.443094 19.776722 19.670510 +2596 456 4 0 6.730151 19.191868 19.918965 +2597 456 4 0 7.622698 19.719431 18.722036 +2598 457 6 0 24.425946 4.299128 7.836287 +2599 457 4 0 24.143986 5.210765 7.985415 +2600 457 4 0 24.990386 4.054602 8.572061 +2601 458 6 0 -3.501704 -11.679155 -10.742632 +2602 458 4 0 -4.397462 -12.025343 -10.633214 +2603 458 4 0 -3.405610 -11.663721 -11.695424 +2604 459 6 0 0.913373 -18.230470 16.876362 +2605 459 4 0 0.053834 -18.577145 16.706546 +2606 459 4 0 1.398023 -19.065707 17.119688 +2607 460 6 0 -9.901596 19.393938 15.691257 +2608 460 4 0 -9.078500 18.954279 15.490614 +2609 460 4 0 -10.185869 18.992605 16.470215 +2610 461 6 0 17.500333 8.706246 -1.323866 +2611 461 4 0 18.176182 9.357546 -1.088149 +2612 461 4 0 17.886380 7.895975 -1.087485 +2613 462 6 0 -24.806806 -14.651049 -14.711674 +2614 462 4 0 -23.905722 -14.363057 -14.892641 +2615 462 4 0 -25.324843 -13.797568 -14.671497 +2616 463 6 0 -11.922848 -15.711273 -13.536344 +2617 463 4 0 -11.771327 -16.170114 -14.379176 +2618 463 4 0 -11.859275 -16.406199 -12.902056 +2619 464 6 0 -27.003017 7.585104 3.060101 +2620 464 4 0 -26.800446 6.932155 2.407207 +2621 464 4 0 -26.438815 7.393710 3.843574 +2622 465 6 0 -10.312090 7.223617 10.185454 +2623 465 4 0 -10.405406 7.379966 11.161275 +2624 465 4 0 -9.783333 6.436443 10.181461 +2625 466 6 0 23.537015 20.390749 -9.649267 +2626 466 4 0 23.323982 21.198505 -9.168669 +2627 466 4 0 23.931089 19.837314 -8.973454 +2628 467 6 0 -17.448795 -20.856696 -12.629322 +2629 467 4 0 -17.613855 -21.585186 -13.226336 +2630 467 4 0 -18.268235 -20.483922 -12.239203 +2631 468 6 0 -5.704053 -12.831319 -13.206852 +2632 468 4 0 -6.332034 -12.109323 -13.311978 +2633 468 4 0 -4.837836 -12.573450 -13.575508 +2634 469 6 0 -7.475606 18.168410 15.238194 +2635 469 4 0 -6.927022 17.679409 15.798229 +2636 469 4 0 -6.978971 18.983237 14.964387 +2637 470 6 0 23.258739 11.168040 16.596096 +2638 470 4 0 23.818087 11.847416 16.270136 +2639 470 4 0 23.610710 10.307417 16.344734 +2640 471 6 0 3.146606 8.327361 -18.713397 +2641 471 4 0 3.334432 7.845623 -19.520851 +2642 471 4 0 3.621381 9.175132 -18.785471 +2643 472 6 0 0.508878 16.181859 6.176221 +2644 472 4 0 1.478661 16.383107 6.127134 +2645 472 4 0 0.329178 16.140784 7.185704 +2646 473 6 0 -11.810390 15.699273 5.840977 +2647 473 4 0 -12.031355 16.450687 6.361038 +2648 473 4 0 -10.941390 15.840688 5.470174 +2649 474 6 0 16.703781 -6.435675 -7.458235 +2650 474 4 0 15.950366 -6.851824 -7.907248 +2651 474 4 0 16.319676 -6.119538 -6.579472 +2652 475 6 0 -16.104630 7.738737 15.683306 +2653 475 4 0 -15.741449 7.072122 15.101362 +2654 475 4 0 -15.325944 8.330995 15.966646 +2655 476 6 0 -12.982372 -5.391773 13.641043 +2656 476 4 0 -13.067158 -6.334773 13.565642 +2657 476 4 0 -13.835584 -5.074352 13.303582 +2658 477 6 0 -0.691433 15.384761 -9.798051 +2659 477 4 0 0.035655 15.975465 -9.534555 +2660 477 4 0 -1.411870 15.925295 -10.115684 +2661 478 6 0 22.895397 13.997330 -2.879616 +2662 478 4 0 23.276050 14.805518 -2.488993 +2663 478 4 0 21.981907 14.160579 -3.026251 +2664 479 6 0 -6.947442 -13.379975 4.783672 +2665 479 4 0 -6.469058 -13.127559 4.014561 +2666 479 4 0 -7.365275 -12.581164 5.147764 +2667 480 6 0 -6.156966 10.605862 2.666376 +2668 480 4 0 -6.752949 10.183956 3.255572 +2669 480 4 0 -5.588229 11.111653 3.195145 +2670 481 6 0 17.104300 -12.560553 4.419376 +2671 481 4 0 16.344172 -13.086998 4.734928 +2672 481 4 0 17.420711 -11.981042 5.141534 +2673 482 6 0 -27.199948 7.334242 -15.333048 +2674 482 4 0 -26.297948 6.895160 -15.306746 +2675 482 4 0 -27.693886 6.547850 -15.268217 +2676 483 6 0 18.024202 -19.856328 -19.395594 +2677 483 4 0 18.487766 -20.698158 -19.394705 +2678 483 4 0 17.496643 -19.929970 -20.262172 +2679 484 6 0 22.144036 -16.812143 16.683717 +2680 484 4 0 21.875393 -16.308766 15.860916 +2681 484 4 0 22.479620 -17.614693 16.338233 +2682 485 6 0 25.514687 -13.472113 7.132093 +2683 485 4 0 25.319079 -13.294653 8.096235 +2684 485 4 0 25.494887 -12.570062 6.821050 +2685 486 6 0 -12.445347 -17.163112 -18.161764 +2686 486 4 0 -13.331012 -16.853903 -17.823843 +2687 486 4 0 -12.475852 -18.105485 -18.058376 +2688 487 6 0 6.245110 16.618836 2.470683 +2689 487 4 0 5.362728 16.987415 2.415415 +2690 487 4 0 6.013984 15.709339 2.583315 +2691 488 6 0 -7.618060 -8.630004 1.461475 +2692 488 4 0 -8.009714 -7.788174 1.663581 +2693 488 4 0 -7.300014 -8.871099 2.309214 +2694 489 6 0 1.276161 -5.724890 -17.027124 +2695 489 4 0 0.639753 -5.451556 -16.374073 +2696 489 4 0 1.572713 -6.534640 -16.615769 +2697 490 6 0 20.941259 -12.865847 16.430327 +2698 490 4 0 21.406858 -13.389929 15.801253 +2699 490 4 0 21.410092 -12.085207 16.695307 +2700 491 6 0 18.670123 -9.367430 14.139852 +2701 491 4 0 17.803568 -9.004865 14.207764 +2702 491 4 0 18.435630 -10.292015 14.355155 +2703 492 6 0 15.733761 -0.209804 0.007017 +2704 492 4 0 15.513443 -0.802742 -0.762427 +2705 492 4 0 15.180436 -0.596633 0.738607 +2706 493 6 0 20.535815 18.401459 7.207233 +2707 493 4 0 20.172747 18.499555 8.120342 +2708 493 4 0 19.715556 18.443909 6.669483 +2709 494 6 0 -19.654075 2.825062 1.617329 +2710 494 4 0 -20.035859 3.209607 2.473368 +2711 494 4 0 -19.137175 3.619122 1.285240 +2712 495 6 0 -5.984107 19.675136 -16.959798 +2713 495 4 0 -5.160819 19.281994 -17.190879 +2714 495 4 0 -5.770973 20.610003 -16.990477 +2715 496 6 0 26.042716 7.197405 -0.343564 +2716 496 4 0 26.688586 6.461363 -0.227844 +2717 496 4 0 25.557638 7.239657 0.456505 +2718 497 6 0 22.024763 3.604615 -12.891547 +2719 497 4 0 21.193970 3.808969 -13.364435 +2720 497 4 0 22.195897 4.401136 -12.384999 +2721 498 6 0 -27.135160 -9.370585 20.643959 +2722 498 4 0 -28.030228 -9.176750 20.474699 +2723 498 4 0 -26.577987 -8.800343 20.128692 +2724 499 6 0 8.395602 -17.119113 3.456766 +2725 499 4 0 8.859834 -17.667269 2.833722 +2726 499 4 0 7.655636 -17.591648 3.745120 +2727 500 6 0 -24.404359 -0.181200 15.657271 +2728 500 4 0 -25.038728 0.161741 16.314921 +2729 500 4 0 -24.896501 -0.279136 14.882179 +2730 501 6 0 -6.891560 5.632315 -20.701537 +2731 501 4 0 -7.366523 6.287143 -21.223329 +2732 501 4 0 -7.630504 5.050659 -20.462604 +2733 502 6 0 -15.566391 -18.747028 -6.177602 +2734 502 4 0 -15.142312 -18.219593 -5.559758 +2735 502 4 0 -16.127679 -19.358388 -5.691405 +2736 503 6 0 -3.401719 -8.548294 5.789954 +2737 503 4 0 -3.203950 -7.652649 5.894670 +2738 503 4 0 -3.475505 -8.723091 4.829013 +2739 504 6 0 -14.869473 17.641299 -11.130330 +2740 504 4 0 -15.356466 18.395479 -10.824746 +2741 504 4 0 -14.164630 17.932079 -11.714816 +2742 505 6 0 -8.566470 9.810858 18.580750 +2743 505 4 0 -7.826026 10.409943 18.459685 +2744 505 4 0 -8.595914 9.242196 17.832030 +2745 506 6 0 15.884351 -0.825682 -9.976397 +2746 506 4 0 16.580456 -1.202192 -10.550817 +2747 506 4 0 16.179129 0.090931 -10.023947 +2748 507 6 0 -6.440363 -16.182406 14.932475 +2749 507 4 0 -5.547886 -16.002472 14.729390 +2750 507 4 0 -6.819275 -16.083044 14.039020 +2751 508 6 0 -15.767451 -12.920838 -5.752541 +2752 508 4 0 -14.944068 -12.805684 -5.287481 +2753 508 4 0 -15.473066 -13.122281 -6.647708 +2754 509 6 0 -17.665031 -20.836176 14.939409 +2755 509 4 0 -16.990389 -21.130134 14.286529 +2756 509 4 0 -18.400170 -20.675073 14.279982 +2757 510 6 0 -22.492854 -19.049287 15.743348 +2758 510 4 0 -23.226808 -19.456562 15.249983 +2759 510 4 0 -22.430818 -19.617870 16.566271 +2760 511 6 0 18.577331 8.130140 -4.339187 +2761 511 4 0 19.102086 8.936870 -4.101075 +2762 511 4 0 17.943090 8.097223 -3.622023 +2763 512 6 0 -8.059195 -11.528283 11.014399 +2764 512 4 0 -8.491272 -11.206486 10.183267 +2765 512 4 0 -7.559001 -12.278215 10.621240 +2766 513 6 0 -0.354476 13.050972 -11.242317 +2767 513 4 0 -0.049943 12.197330 -10.889757 +2768 513 4 0 -0.319360 13.679003 -10.509947 +2769 514 6 0 -22.692724 -6.768839 -13.959385 +2770 514 4 0 -22.638060 -6.234744 -13.112330 +2771 514 4 0 -22.909077 -7.637803 -13.626522 +2772 515 6 0 4.453531 -16.513982 -10.118567 +2773 515 4 0 5.009279 -17.005000 -9.492769 +2774 515 4 0 4.837806 -15.680507 -10.286610 +2775 516 6 0 -14.211895 -3.759096 -20.057898 +2776 516 4 0 -14.318355 -2.866044 -19.740155 +2777 516 4 0 -13.541901 -3.847665 -20.736218 +2778 517 6 0 26.693079 9.858450 -14.505848 +2779 517 4 0 26.995219 9.161898 -15.033866 +2780 517 4 0 25.767285 9.604872 -14.294807 +2781 518 6 0 -1.593304 -2.461499 11.764930 +2782 518 4 0 -0.575245 -2.524541 11.545614 +2783 518 4 0 -1.885036 -1.661756 11.286623 +2784 519 6 0 -19.660824 -20.494500 2.235869 +2785 519 4 0 -20.078029 -21.333649 2.487444 +2786 519 4 0 -19.181632 -20.681107 1.379436 +2787 520 6 0 4.144088 17.144901 -7.996934 +2788 520 4 0 4.141310 16.441147 -7.303669 +2789 520 4 0 3.204041 17.192031 -8.237159 +2790 521 6 0 24.148563 16.188551 14.675204 +2791 521 4 0 24.234269 17.058984 15.034647 +2792 521 4 0 23.773522 16.320292 13.788777 +2793 522 6 0 -11.859704 2.830217 -15.811214 +2794 522 4 0 -12.674780 3.212291 -15.481544 +2795 522 4 0 -11.777095 3.234540 -16.701788 +2796 523 6 0 -14.309989 12.182667 1.560506 +2797 523 4 0 -13.393237 12.215837 1.842065 +2798 523 4 0 -14.715876 12.517376 2.368763 +2799 524 6 0 -7.611903 8.096548 -15.149217 +2800 524 4 0 -8.323994 7.679983 -15.518143 +2801 524 4 0 -6.945506 8.015221 -15.887869 +2802 525 6 0 -19.095296 -11.187670 -3.400222 +2803 525 4 0 -19.337682 -11.939672 -2.902754 +2804 525 4 0 -18.131286 -10.890144 -3.347747 +2805 526 6 0 -3.684618 -18.692360 -9.413075 +2806 526 4 0 -3.418979 -17.929749 -9.940845 +2807 526 4 0 -2.916246 -19.202389 -9.257694 +2808 527 6 0 -24.383366 4.449647 -2.247488 +2809 527 4 0 -24.017217 3.645809 -1.897604 +2810 527 4 0 -24.220917 5.021187 -1.511294 +2811 528 6 0 -19.731647 -12.211221 2.860739 +2812 528 4 0 -19.245645 -12.129462 2.005512 +2813 528 4 0 -20.512036 -12.824760 2.628969 +2814 529 6 0 -4.683560 -15.770086 9.389938 +2815 529 4 0 -5.061246 -15.024625 8.860317 +2816 529 4 0 -5.320477 -16.506457 9.373591 +2817 530 6 0 -4.887399 -5.093738 -15.497549 +2818 530 4 0 -5.401164 -5.893295 -15.248311 +2819 530 4 0 -4.758120 -4.537262 -14.717756 +2820 531 6 0 -14.685481 -17.958902 -3.365836 +2821 531 4 0 -14.177516 -17.147605 -3.110889 +2822 531 4 0 -15.533211 -17.687906 -3.096067 +2823 532 6 0 24.950357 10.761179 -11.253927 +2824 532 4 0 25.623382 10.724523 -10.501653 +2825 532 4 0 24.912589 11.668740 -11.614144 +2826 533 6 0 5.896274 1.022377 5.410141 +2827 533 4 0 5.144364 0.409378 5.470882 +2828 533 4 0 6.702894 0.529043 5.601445 +2829 534 6 0 -10.707964 -12.538200 -15.636360 +2830 534 4 0 -11.433886 -12.205371 -16.086670 +2831 534 4 0 -10.099661 -13.047707 -16.220825 +2832 535 6 0 25.311857 10.178415 6.672916 +2833 535 4 0 25.652073 11.053667 6.645762 +2834 535 4 0 25.462543 9.793786 5.796182 +2835 536 6 0 13.351375 -13.843752 2.567223 +2836 536 4 0 12.454525 -14.099339 2.561046 +2837 536 4 0 13.804123 -14.196570 1.793439 +2838 537 6 0 6.447086 -1.674870 18.025371 +2839 537 4 0 6.966001 -2.437397 17.753314 +2840 537 4 0 5.596824 -1.849843 17.645605 +2841 538 6 0 -7.195562 13.506129 2.012549 +2842 538 4 0 -6.788362 12.635839 2.194379 +2843 538 4 0 -6.577836 13.973475 1.500153 +2844 539 6 0 13.594384 20.297397 2.445796 +2845 539 4 0 13.788282 19.607477 3.108308 +2846 539 4 0 13.006415 19.871282 1.852966 +2847 540 6 0 15.233611 0.850818 -5.243920 +2848 540 4 0 15.311708 1.467460 -4.483590 +2849 540 4 0 15.351381 1.519810 -6.000951 +2850 541 6 0 -21.392858 -6.660913 15.084747 +2851 541 4 0 -21.093136 -6.580317 16.005763 +2852 541 4 0 -20.482050 -6.866879 14.680665 +2853 542 6 0 21.798067 9.236981 0.429299 +2854 542 4 0 22.425954 9.071754 -0.267587 +2855 542 4 0 21.188410 9.810447 0.032847 +2856 543 6 0 -16.844679 -14.439050 3.033305 +2857 543 4 0 -17.236824 -14.606294 2.191567 +2858 543 4 0 -17.149528 -13.681189 3.446869 +2859 544 6 0 -16.118636 -14.695009 11.770906 +2860 544 4 0 -16.061462 -15.566570 12.219315 +2861 544 4 0 -15.401385 -14.815928 11.092232 +2862 545 6 0 -25.116635 -0.336266 -13.211265 +2863 545 4 0 -26.034773 -0.593788 -13.205266 +2864 545 4 0 -25.075870 0.263017 -13.996810 +2865 546 6 0 -20.959975 8.707771 -3.841257 +2866 546 4 0 -20.129335 8.189240 -3.711541 +2867 546 4 0 -21.648123 8.152127 -4.150679 +2868 547 6 0 -16.180937 -14.560529 -11.236167 +2869 547 4 0 -16.474551 -15.471407 -11.472150 +2870 547 4 0 -16.621414 -14.329172 -10.425074 +2871 548 6 0 -13.342695 17.268978 -5.546108 +2872 548 4 0 -13.676329 17.161979 -6.427016 +2873 548 4 0 -13.273106 16.392331 -5.194906 +2874 549 6 0 -24.265742 -14.933019 -6.702562 +2875 549 4 0 -23.594698 -14.475474 -7.192272 +2876 549 4 0 -24.769412 -14.353533 -6.144027 +2877 550 6 0 -7.448634 4.091980 -14.623254 +2878 550 4 0 -8.354031 4.372416 -14.477512 +2879 550 4 0 -7.429422 3.997857 -15.560262 +2880 551 6 0 20.945964 8.392028 7.273218 +2881 551 4 0 20.936526 8.748124 8.157739 +2882 551 4 0 21.409383 8.938927 6.671909 +2883 552 6 0 -18.135613 13.691026 0.855516 +2884 552 4 0 -17.605509 13.473951 1.604996 +2885 552 4 0 -17.989769 12.903203 0.328977 +2886 553 6 0 -26.399609 20.299424 -15.455568 +2887 553 4 0 -26.506532 19.402038 -15.778173 +2888 553 4 0 -27.208559 20.540561 -15.036657 +2889 554 6 0 -3.382080 16.857093 -8.397864 +2890 554 4 0 -3.374084 16.083688 -7.808965 +2891 554 4 0 -4.084724 16.687463 -9.043127 +2892 555 6 0 16.271526 -9.902746 -4.216439 +2893 555 4 0 16.409251 -10.505040 -3.454487 +2894 555 4 0 15.497720 -10.304168 -4.762308 +2895 556 6 0 14.340659 -16.032990 13.215463 +2896 556 4 0 13.501340 -15.882091 13.690140 +2897 556 4 0 14.455052 -15.349188 12.509336 +2898 557 6 0 -0.015146 -13.033200 3.303743 +2899 557 4 0 -0.181704 -13.007242 2.346702 +2900 557 4 0 0.267440 -13.997638 3.485458 +2901 558 6 0 17.219995 5.155984 2.579305 +2902 558 4 0 17.867362 4.521907 2.914585 +2903 558 4 0 17.421034 5.907098 3.091911 +2904 559 6 0 -4.290476 -8.859344 10.315396 +2905 559 4 0 -4.367776 -8.058305 9.793864 +2906 559 4 0 -4.232508 -9.643259 9.792086 +2907 560 6 0 -26.107401 19.840481 -9.535848 +2908 560 4 0 -25.152722 20.076292 -9.710007 +2909 560 4 0 -26.580648 20.657816 -9.784705 +2910 561 6 0 22.430740 12.824805 -18.610921 +2911 561 4 0 22.555563 12.342166 -17.752607 +2912 561 4 0 21.710766 13.488004 -18.415345 +2913 562 6 0 -0.213702 15.539427 8.868930 +2914 562 4 0 0.465115 15.308974 9.514310 +2915 562 4 0 -0.991140 15.165260 9.301737 +2916 563 6 0 10.451773 19.296672 -15.739638 +2917 563 4 0 11.250242 18.716315 -15.675225 +2918 563 4 0 10.166040 19.254066 -16.609341 +2919 564 6 0 -16.340404 20.299845 -6.677501 +2920 564 4 0 -15.394517 20.367214 -6.949699 +2921 564 4 0 -16.411819 19.609339 -6.000069 +2922 565 6 0 17.490554 18.048717 15.249869 +2923 565 4 0 17.383710 17.561453 14.453086 +2924 565 4 0 17.231849 18.986361 14.979711 +2925 566 6 0 -25.356900 0.960567 -15.630378 +2926 566 4 0 -25.668408 1.746466 -16.112686 +2927 566 4 0 -25.749312 0.266373 -16.283472 +2928 567 6 0 -24.523491 12.684913 -13.612913 +2929 567 4 0 -25.162839 13.082234 -14.200312 +2930 567 4 0 -24.857615 11.766450 -13.558078 +2931 568 6 0 -18.320478 -19.787535 -8.552256 +2932 568 4 0 -17.456232 -20.243682 -8.416866 +2933 568 4 0 -18.816764 -20.212417 -7.902570 +2934 569 6 0 -20.122796 -19.443402 14.311268 +2935 569 4 0 -20.955070 -19.458490 14.740741 +2936 569 4 0 -20.448309 -19.736012 13.412761 +2937 570 6 0 15.526182 9.609189 7.445275 +2938 570 4 0 16.546971 9.522464 7.260687 +2939 570 4 0 15.127662 8.717624 7.262881 +2940 571 6 0 21.815800 -13.876078 19.805359 +2941 571 4 0 21.861374 -13.448639 20.652235 +2942 571 4 0 20.873448 -13.977249 19.618277 +2943 572 6 0 -20.455209 -17.485281 2.435687 +2944 572 4 0 -20.514677 -18.504590 2.320539 +2945 572 4 0 -19.650253 -17.416617 3.035233 +2946 573 6 0 12.598962 20.934840 -8.411100 +2947 573 4 0 11.759105 20.691141 -7.924616 +2948 573 4 0 12.471156 20.908914 -9.376870 +2949 574 6 0 -9.216318 -10.756192 8.704342 +2950 574 4 0 -9.035829 -9.823066 8.964150 +2951 574 4 0 -10.158700 -10.965843 8.822969 +2952 575 6 0 15.481710 -19.357119 -11.731342 +2953 575 4 0 16.266851 -18.921549 -11.423511 +2954 575 4 0 15.782813 -20.280095 -11.705706 +2955 576 6 0 -15.247931 17.174276 -3.500551 +2956 576 4 0 -15.486872 16.716297 -4.319984 +2957 576 4 0 -14.488844 17.725770 -3.787040 +2958 577 6 0 13.994416 -17.236082 0.675362 +2959 577 4 0 14.353425 -17.278489 1.570062 +2960 577 4 0 14.236303 -16.341554 0.403337 +2961 578 6 0 -23.467726 19.561551 3.571514 +2962 578 4 0 -24.004822 19.287615 4.359125 +2963 578 4 0 -22.609407 19.390622 3.887076 +2964 579 6 0 -18.884839 -16.840019 19.441419 +2965 579 4 0 -17.972164 -16.942648 19.429089 +2966 579 4 0 -19.117567 -17.305223 18.656489 +2967 580 6 0 -3.304416 17.688255 14.806768 +2968 580 4 0 -3.274068 18.569163 15.273992 +2969 580 4 0 -3.909468 17.884508 14.115697 +2970 581 6 0 -17.284600 -14.419545 -3.713924 +2971 581 4 0 -17.245841 -15.056389 -4.407408 +2972 581 4 0 -16.814676 -13.644893 -4.121390 +2973 582 6 0 -20.198946 13.854179 -11.126603 +2974 582 4 0 -19.842134 14.641594 -10.704689 +2975 582 4 0 -20.994231 13.579588 -10.762730 +2976 583 6 0 19.633175 -4.534579 -1.940156 +2977 583 4 0 20.573656 -4.404910 -1.787896 +2978 583 4 0 19.476036 -5.006335 -2.786939 +2979 584 6 0 -14.050747 -7.840313 -20.451392 +2980 584 4 0 -13.804502 -7.885621 -19.536069 +2981 584 4 0 -14.163116 -8.770871 -20.729134 +2982 585 6 0 -22.035810 -14.696947 -15.342419 +2983 585 4 0 -21.244458 -14.172213 -14.968853 +2984 585 4 0 -21.709618 -15.071176 -16.129917 +2985 586 6 0 24.404519 18.662499 15.604580 +2986 586 4 0 23.649634 19.231742 15.720672 +2987 586 4 0 24.564861 18.257635 16.462026 +2988 587 6 0 -25.023703 1.632995 9.069342 +2989 587 4 0 -24.924833 0.728361 9.205894 +2990 587 4 0 -25.848027 1.691778 8.537435 +2991 588 6 0 -23.501597 20.098664 7.878789 +2992 588 4 0 -23.060988 19.669189 7.073786 +2993 588 4 0 -24.179799 19.453525 8.025704 +2994 589 6 0 -19.949605 3.791557 -8.640569 +2995 589 4 0 -20.735484 4.236110 -9.006112 +2996 589 4 0 -20.021037 3.910265 -7.668204 +2997 590 6 0 -11.039604 7.965462 12.985718 +2998 590 4 0 -11.657528 7.295810 13.344834 +2999 590 4 0 -11.533657 8.735729 12.733347 +3000 591 6 0 -10.874373 -9.234080 16.940331 +3001 591 4 0 -10.287226 -8.454268 16.808084 +3002 591 4 0 -10.829657 -9.367499 17.890097 +3003 592 6 0 -14.385649 -14.739019 19.039927 +3004 592 4 0 -15.014366 -15.430322 18.739868 +3005 592 4 0 -13.950162 -14.385374 18.202705 +3006 593 6 0 -8.943007 -18.707640 -12.863046 +3007 593 4 0 -8.324251 -18.030317 -12.441569 +3008 593 4 0 -8.503951 -19.555164 -12.986191 +3009 594 6 0 -12.368468 -11.299670 18.862003 +3010 594 4 0 -11.462838 -11.162374 19.089512 +3011 594 4 0 -12.285975 -11.967140 18.162474 +3012 595 6 0 -18.864908 10.893225 -18.642183 +3013 595 4 0 -19.737729 11.286548 -18.797146 +3014 595 4 0 -18.291730 11.691326 -18.413733 +3015 596 6 0 13.738555 -10.387697 15.727067 +3016 596 4 0 14.677946 -10.190824 15.738680 +3017 596 4 0 13.381035 -9.878174 14.979047 +3018 597 6 0 -21.819721 -0.482540 -14.130337 +3019 597 4 0 -22.018580 0.101499 -14.814948 +3020 597 4 0 -21.732054 0.043937 -13.284517 +3021 598 6 0 -22.088145 -19.005770 -10.424446 +3022 598 4 0 -22.700458 -18.735873 -11.127116 +3023 598 4 0 -22.265806 -18.243802 -9.851663 +3024 599 6 0 -27.334131 16.862943 6.388414 +3025 599 4 0 -27.128884 17.208336 5.542208 +3026 599 4 0 -28.186942 16.459356 6.245911 +3027 600 6 0 -7.724914 11.617317 -15.852447 +3028 600 4 0 -7.898781 11.683763 -14.888607 +3029 600 4 0 -7.243883 12.459704 -15.934395 +3030 601 6 0 -27.430510 7.062419 7.641894 +3031 601 4 0 -28.241619 7.496835 7.830929 +3032 601 4 0 -26.905937 6.864821 8.456222 +3033 602 6 0 -15.189130 9.068233 11.973047 +3034 602 4 0 -15.507439 9.270556 11.066477 +3035 602 4 0 -16.000569 9.109399 12.508881 +3036 603 6 0 18.197719 -8.444367 -5.807006 +3037 603 4 0 17.669265 -7.953475 -6.477556 +3038 603 4 0 17.491033 -8.840952 -5.199557 +3039 604 6 0 -17.798267 -15.359279 0.720984 +3040 604 4 0 -17.605358 -16.253295 0.449070 +3041 604 4 0 -18.769315 -15.298569 0.739208 +3042 605 6 0 -10.801299 19.625083 -5.021468 +3043 605 4 0 -9.963843 19.123292 -5.234694 +3044 605 4 0 -10.501894 20.547773 -4.927487 +3045 606 6 0 -27.215648 6.353394 -6.216686 +3046 606 4 0 -27.824477 6.975672 -6.597897 +3047 606 4 0 -27.715217 5.539077 -6.142494 +3048 607 6 0 -20.222710 16.482564 20.889728 +3049 607 4 0 -19.409945 15.875063 20.936404 +3050 607 4 0 -20.827135 16.165289 21.596363 +3051 608 6 0 -15.955148 20.970093 -1.473146 +3052 608 4 0 -16.254513 20.076270 -1.042106 +3053 608 4 0 -15.662348 21.552087 -0.814219 +3054 609 6 0 10.807526 -13.982475 1.662510 +3055 609 4 0 10.120672 -14.259351 2.204544 +3056 609 4 0 10.863967 -13.021251 1.772688 +3057 610 6 0 -7.966458 -18.779639 13.245673 +3058 610 4 0 -7.309099 -18.332730 12.718011 +3059 610 4 0 -8.719738 -18.984231 12.613154 +3060 611 6 0 -20.403821 -13.506340 10.662924 +3061 611 4 0 -20.510093 -14.184751 11.331921 +3062 611 4 0 -19.449692 -13.488641 10.607253 +3063 612 6 0 3.347403 17.582790 14.279585 +3064 612 4 0 3.542375 16.697267 14.539882 +3065 612 4 0 3.842808 18.157712 14.875497 +3066 613 6 0 -27.268704 11.599332 7.521962 +3067 613 4 0 -27.319935 12.603952 7.610238 +3068 613 4 0 -27.760414 11.222738 8.251319 +3069 614 6 0 -13.558625 -13.571833 9.018373 +3070 614 4 0 -14.134501 -13.113855 9.622383 +3071 614 4 0 -13.282735 -12.952963 8.287428 +3072 615 6 0 -12.904629 4.779698 8.188511 +3073 615 4 0 -12.946789 5.709486 7.819080 +3074 615 4 0 -13.125056 4.225008 7.389046 +3075 616 6 0 -26.521845 8.632500 -1.585840 +3076 616 4 0 -27.252112 8.571224 -0.926514 +3077 616 4 0 -27.101821 8.697912 -2.395641 +3078 617 6 0 0.711352 18.247453 15.282784 +3079 617 4 0 1.603697 18.249814 14.962197 +3080 617 4 0 0.201613 17.732907 14.670147 +3081 618 6 0 7.113451 16.228888 -1.466776 +3082 618 4 0 7.173117 15.305699 -1.111399 +3083 618 4 0 7.220512 16.670305 -0.601189 +3084 619 6 0 -13.904243 8.625524 20.904818 +3085 619 4 0 -14.598235 8.427161 20.276223 +3086 619 4 0 -13.595573 9.537530 20.812383 +3087 620 6 0 -23.282747 7.422865 -4.367991 +3088 620 4 0 -23.494082 7.124036 -5.259399 +3089 620 4 0 -24.056516 7.114406 -3.864243 +3090 621 6 0 -14.263410 11.647626 -16.485013 +3091 621 4 0 -14.250457 12.591263 -16.217484 +3092 621 4 0 -13.447733 11.223560 -16.266518 +3093 622 6 0 -25.123489 -11.752131 6.663069 +3094 622 4 0 -24.434538 -11.175706 6.315833 +3095 622 4 0 -24.632736 -12.584077 6.767142 +3096 623 6 0 -14.146070 -17.326290 5.680123 +3097 623 4 0 -13.644335 -16.487658 5.902302 +3098 623 4 0 -14.878124 -17.344106 6.279009 +3099 624 6 0 -20.598314 9.096753 20.421892 +3100 624 4 0 -21.420000 9.436011 20.788368 +3101 624 4 0 -20.773261 8.800990 19.535216 +3102 625 6 0 18.231067 -8.355182 -15.374644 +3103 625 4 0 19.158997 -8.699272 -15.469475 +3104 625 4 0 18.162062 -7.866000 -14.601450 +3105 626 6 0 -26.082795 17.419257 -15.113528 +3106 626 4 0 -26.663305 16.880075 -15.659385 +3107 626 4 0 -26.614420 17.764627 -14.366811 +3108 627 6 0 -4.564502 -6.365364 18.192018 +3109 627 4 0 -4.423912 -6.577366 17.248668 +3110 627 4 0 -4.413382 -7.162274 18.732886 +3111 628 6 0 2.994631 -20.344673 -10.462592 +3112 628 4 0 3.336979 -19.647973 -11.071544 +3113 628 4 0 2.839013 -21.162093 -11.031196 +3114 629 6 0 -18.808948 18.745667 8.606647 +3115 629 4 0 -18.793078 17.928925 9.047490 +3116 629 4 0 -19.375318 18.782786 7.854831 +3117 630 6 0 20.293384 6.483656 -8.185168 +3118 630 4 0 19.822775 6.335085 -7.339796 +3119 630 4 0 19.910867 5.733330 -8.676027 +3120 631 6 0 14.001637 -11.377427 6.654390 +3121 631 4 0 14.665802 -10.891103 7.186571 +3122 631 4 0 13.155623 -11.243569 7.110824 +3123 632 6 0 -18.716197 16.452296 -6.146582 +3124 632 4 0 -17.737092 16.308167 -6.065641 +3125 632 4 0 -18.803071 17.441704 -6.266673 +3126 633 6 0 -9.164502 -4.245435 9.687071 +3127 633 4 0 -9.504754 -3.618059 10.271725 +3128 633 4 0 -8.758976 -4.901714 10.277390 +3129 634 6 0 -7.567104 17.996846 -14.273209 +3130 634 4 0 -7.423981 17.432000 -15.103459 +3131 634 4 0 -7.626914 17.354562 -13.501068 +3132 635 6 0 25.957404 18.297560 0.964228 +3133 635 4 0 26.373386 18.902213 1.607245 +3134 635 4 0 24.996135 18.298154 0.948557 +3135 636 6 0 27.365655 -19.507447 4.283366 +3136 636 4 0 27.265808 -18.590346 4.470644 +3137 636 4 0 27.346229 -19.502059 3.318095 +3138 637 6 0 3.399017 3.842973 -14.306661 +3139 637 4 0 3.874219 4.645706 -14.438487 +3140 637 4 0 3.960550 3.060792 -14.302404 +3141 638 6 0 -9.633558 -14.252688 -13.074954 +3142 638 4 0 -10.397961 -14.800052 -13.280458 +3143 638 4 0 -9.599658 -13.580050 -13.748986 +3144 639 6 0 -26.597184 -9.526044 16.214934 +3145 639 4 0 -25.761551 -9.704064 15.705422 +3146 639 4 0 -26.282395 -9.291353 17.107825 +3147 640 6 0 9.904852 -8.080714 13.028578 +3148 640 4 0 9.633649 -8.672937 13.775436 +3149 640 4 0 9.328640 -8.216914 12.289674 +3150 641 6 0 -16.656465 -15.275719 14.920535 +3151 641 4 0 -16.332015 -16.176602 15.149012 +3152 641 4 0 -17.604168 -15.312599 15.097227 +3153 642 6 0 -23.632856 16.383578 4.244499 +3154 642 4 0 -24.439865 15.907903 4.567947 +3155 642 4 0 -23.758905 16.459340 3.297146 +3156 643 6 0 6.174822 3.396366 6.558333 +3157 643 4 0 6.411031 3.086511 7.491490 +3158 643 4 0 5.914298 2.639627 6.072475 +3159 644 6 0 -12.394642 12.999960 5.615295 +3160 644 4 0 -12.767249 13.829992 5.894454 +3161 644 4 0 -11.542368 12.942527 6.067628 +3162 645 6 0 -13.943061 -10.506777 -8.106784 +3163 645 4 0 -14.282580 -10.512566 -7.188555 +3164 645 4 0 -13.832495 -9.541181 -8.393822 +3165 646 6 0 -2.132377 12.062639 -15.645930 +3166 646 4 0 -2.521581 12.726985 -15.116060 +3167 646 4 0 -2.383415 12.256835 -16.605675 +3168 647 6 0 -15.781380 4.295423 -12.837615 +3169 647 4 0 -16.545564 4.857521 -12.623883 +3170 647 4 0 -14.991403 4.649584 -12.386947 +3171 648 6 0 3.657686 -14.899636 11.284985 +3172 648 4 0 4.599918 -15.027083 11.351362 +3173 648 4 0 3.451904 -14.114684 10.742312 +3174 649 6 0 -13.445931 -12.269834 -16.644595 +3175 649 4 0 -13.143553 -12.206221 -17.543310 +3176 649 4 0 -14.277341 -11.802665 -16.570144 +3177 650 6 0 -4.514598 -14.412565 -11.239008 +3178 650 4 0 -4.912249 -14.782052 -10.430067 +3179 650 4 0 -5.207582 -13.911802 -11.682506 +3180 651 6 0 -22.202449 -8.277754 -0.156304 +3181 651 4 0 -21.822932 -9.154115 -0.107154 +3182 651 4 0 -22.081748 -7.881016 0.675063 +3183 652 6 0 5.980605 9.643233 7.937147 +3184 652 4 0 5.778293 9.935793 8.831204 +3185 652 4 0 6.322796 10.408255 7.426496 +3186 653 6 0 -2.201607 -16.515113 -14.210032 +3187 653 4 0 -2.059974 -15.558981 -14.035317 +3188 653 4 0 -1.990188 -17.058199 -13.410631 +3189 654 6 0 18.679591 -18.705711 14.460946 +3190 654 4 0 18.696979 -17.793354 14.872009 +3191 654 4 0 19.598133 -18.732862 14.241557 +3192 655 6 0 -23.704300 9.078870 13.078638 +3193 655 4 0 -23.670653 8.205186 13.541582 +3194 655 4 0 -24.192847 9.646015 13.627775 +3195 656 6 0 -2.173657 16.833015 -11.939576 +3196 656 4 0 -1.811491 16.347920 -12.704849 +3197 656 4 0 -1.445451 17.452841 -11.775832 +3198 657 6 0 13.483501 -11.256705 11.913651 +3199 657 4 0 12.870120 -10.662512 12.431360 +3200 657 4 0 14.331458 -10.851122 11.936251 +3201 658 6 0 24.414471 -17.245267 11.179269 +3202 658 4 0 25.211262 -16.789228 11.385933 +3203 658 4 0 24.640242 -18.219159 11.091473 +3204 659 6 0 11.120331 -15.111988 5.927148 +3205 659 4 0 11.451561 -14.918986 6.814295 +3206 659 4 0 11.019394 -14.187742 5.582882 +3207 660 6 0 12.007104 -9.600387 4.572911 +3208 660 4 0 11.779325 -9.981896 3.630934 +3209 660 4 0 12.299473 -8.663707 4.379041 +3210 661 6 0 6.432204 5.492806 -11.438378 +3211 661 4 0 6.858563 6.325600 -11.691904 +3212 661 4 0 5.497288 5.536187 -11.496269 +3213 662 6 0 -16.803408 -2.309975 -12.525084 +3214 662 4 0 -17.553689 -1.730249 -12.823644 +3215 662 4 0 -17.150179 -3.188627 -12.867169 +3216 663 6 0 -2.408853 19.363640 5.416041 +3217 663 4 0 -2.506588 20.324223 5.172630 +3218 663 4 0 -1.499205 19.245311 4.997471 +3219 664 6 0 18.335645 9.820504 -20.835302 +3220 664 4 0 17.802051 9.406337 -21.556671 +3221 664 4 0 19.054571 10.173338 -21.326492 +3222 665 6 0 14.492400 -0.793925 15.043220 +3223 665 4 0 15.273199 -0.763837 15.602226 +3224 665 4 0 13.903082 -0.202173 15.510237 +3225 666 6 0 -18.990417 -18.003103 -15.160778 +3226 666 4 0 -19.065422 -18.467887 -14.363137 +3227 666 4 0 -18.682751 -18.771930 -15.707456 +3228 667 6 0 -19.355981 10.428580 -15.655699 +3229 667 4 0 -18.958237 10.419569 -16.503824 +3230 667 4 0 -19.555621 9.469325 -15.477396 +3231 668 6 0 -9.689572 -17.625802 20.274891 +3232 668 4 0 -9.638458 -16.856491 19.680753 +3233 668 4 0 -10.446575 -18.157818 20.089513 +3234 669 6 0 15.818186 -2.858530 -17.669337 +3235 669 4 0 15.374117 -2.032149 -17.355590 +3236 669 4 0 16.772354 -2.603400 -17.785321 +3237 670 6 0 4.606592 -16.002710 16.812249 +3238 670 4 0 5.315620 -15.500456 17.249944 +3239 670 4 0 3.799748 -15.479801 16.918622 +3240 671 6 0 -21.513339 9.988705 -9.339870 +3241 671 4 0 -20.667999 10.159257 -9.025723 +3242 671 4 0 -21.969690 9.708425 -8.552482 +3243 672 6 0 22.932065 -4.395951 1.502838 +3244 672 4 0 23.014854 -3.682098 2.132967 +3245 672 4 0 22.755233 -5.203260 2.068576 +3246 673 6 0 -15.865161 20.547416 -16.433392 +3247 673 4 0 -15.771392 21.394273 -16.845693 +3248 673 4 0 -15.137003 20.501933 -15.748936 +3249 674 6 0 25.069907 -16.838970 -4.299599 +3250 674 4 0 25.999382 -16.506367 -4.277797 +3251 674 4 0 24.882196 -17.073394 -3.399165 +3252 675 6 0 12.210843 -6.139817 11.421079 +3253 675 4 0 11.494183 -5.792293 10.826764 +3254 675 4 0 12.753399 -6.598677 10.772296 +3255 676 6 0 -12.958185 15.721214 20.131937 +3256 676 4 0 -12.417015 15.448234 19.335440 +3257 676 4 0 -12.670185 16.622230 20.361377 +3258 677 6 0 -1.787017 -16.482436 -2.383044 +3259 677 4 0 -1.225925 -16.053148 -3.012278 +3260 677 4 0 -2.501380 -15.880251 -2.214679 +3261 678 6 0 -1.190078 -20.139554 1.294226 +3262 678 4 0 -0.299194 -20.371113 0.969279 +3263 678 4 0 -1.688402 -19.692251 0.619486 +3264 679 6 0 1.937567 -19.455705 20.174807 +3265 679 4 0 1.600890 -18.656647 20.650502 +3266 679 4 0 2.270116 -20.076098 20.862273 +3267 680 6 0 -13.809787 16.178967 11.484043 +3268 680 4 0 -14.142545 15.377181 11.850775 +3269 680 4 0 -14.373329 16.882494 11.935295 +3270 681 6 0 17.196672 -3.298677 9.603341 +3271 681 4 0 17.785156 -3.273949 10.352111 +3272 681 4 0 16.328249 -3.307055 9.989818 +3273 682 6 0 -21.793083 12.953802 -3.361588 +3274 682 4 0 -21.341354 13.824014 -3.442583 +3275 682 4 0 -21.956486 12.886091 -2.420332 +3276 683 6 0 24.722833 -20.214271 -1.932412 +3277 683 4 0 24.583170 -20.295689 -2.905459 +3278 683 4 0 25.266330 -20.988208 -1.659517 +3279 684 6 0 13.576953 15.549687 -14.568922 +3280 684 4 0 13.196035 16.082140 -13.845167 +3281 684 4 0 12.903095 14.935032 -14.704323 +3282 685 6 0 24.686323 18.724782 9.264820 +3283 685 4 0 25.356258 19.231143 8.760904 +3284 685 4 0 24.376076 19.091122 10.133820 +3285 686 6 0 10.974277 8.210457 0.042398 +3286 686 4 0 10.346946 8.747962 0.639501 +3287 686 4 0 11.775308 8.082914 0.592641 +3288 687 6 0 15.749941 -9.949096 -10.535727 +3289 687 4 0 14.881677 -9.994266 -10.933909 +3290 687 4 0 16.082746 -9.069742 -10.712222 +3291 688 6 0 20.372551 -2.740524 -20.295283 +3292 688 4 0 19.972569 -3.556917 -19.910575 +3293 688 4 0 21.117159 -2.669954 -19.650483 +3294 689 6 0 -16.130593 19.525141 7.609103 +3295 689 4 0 -16.988329 19.095523 7.574165 +3296 689 4 0 -15.815635 19.368486 8.484111 +3297 690 6 0 -13.620470 -12.179873 -20.763485 +3298 690 4 0 -13.206848 -12.281384 -21.584939 +3299 690 4 0 -13.003543 -11.952064 -20.092320 +3300 691 6 0 -4.286145 -8.076676 -19.850653 +3301 691 4 0 -4.024629 -8.962570 -19.497729 +3302 691 4 0 -4.628013 -8.265378 -20.732144 +3303 692 6 0 18.167149 11.171401 14.365772 +3304 692 4 0 18.072419 11.267858 15.337991 +3305 692 4 0 19.114984 11.092302 14.227006 +3306 693 6 0 -6.484207 14.268929 15.251307 +3307 693 4 0 -5.622289 14.569256 15.414810 +3308 693 4 0 -6.409671 13.589284 14.542615 +3309 694 6 0 -22.009910 15.740037 8.254841 +3310 694 4 0 -21.174881 15.566577 7.788279 +3311 694 4 0 -21.784303 15.725302 9.211467 +3312 695 6 0 -12.075884 4.855934 18.759604 +3313 695 4 0 -11.922580 5.826978 18.890965 +3314 695 4 0 -11.210639 4.506344 19.097368 +3315 696 6 0 10.488011 -18.196911 -8.466384 +3316 696 4 0 10.637969 -17.211540 -8.520849 +3317 696 4 0 11.163762 -18.500106 -9.085738 +3318 697 6 0 1.125820 20.066151 11.277514 +3319 697 4 0 0.488344 19.358887 11.406985 +3320 697 4 0 1.175707 20.424035 12.220043 +3321 698 6 0 1.508244 -2.375369 14.307932 +3322 698 4 0 0.868346 -1.761280 14.698396 +3323 698 4 0 1.257101 -3.281035 14.657092 +3324 699 6 0 8.333201 -20.303098 14.135689 +3325 699 4 0 8.173342 -20.812430 14.996202 +3326 699 4 0 7.563231 -20.469348 13.580696 +3327 700 6 0 7.161769 13.324939 -3.684466 +3328 700 4 0 6.692561 13.032914 -4.505707 +3329 700 4 0 7.435294 14.252208 -3.751921 +3330 701 6 0 -8.368806 1.641675 18.686706 +3331 701 4 0 -7.449000 1.561105 18.992044 +3332 701 4 0 -8.829402 1.367359 19.523867 +3333 702 6 0 4.081470 8.393376 14.788004 +3334 702 4 0 3.416356 8.289314 15.434673 +3335 702 4 0 3.901559 7.693490 14.181822 +3336 703 6 0 -7.418847 -5.372814 17.842250 +3337 703 4 0 -7.820918 -6.206339 17.693835 +3338 703 4 0 -6.460103 -5.466581 17.841167 +3339 704 6 0 -6.272338 -9.280731 3.614771 +3340 704 4 0 -5.671659 -9.851333 3.097194 +3341 704 4 0 -6.583386 -9.880058 4.252855 +3342 705 6 0 26.867212 -7.498721 15.184014 +3343 705 4 0 27.180613 -8.176302 15.786609 +3344 705 4 0 27.338168 -7.770453 14.373438 +3345 706 6 0 9.996033 -14.570233 13.333736 +3346 706 4 0 9.969634 -13.724445 12.959529 +3347 706 4 0 9.789000 -15.194125 12.559782 +3348 707 6 0 2.391061 -15.016416 -4.564378 +3349 707 4 0 2.249440 -15.150315 -3.614545 +3350 707 4 0 3.332088 -14.950210 -4.710721 +3351 708 6 0 -21.651564 17.273027 -5.114431 +3352 708 4 0 -22.612266 17.402180 -4.967856 +3353 708 4 0 -21.475301 17.110688 -6.035544 +3354 709 6 0 10.670434 18.798919 9.295678 +3355 709 4 0 10.772878 18.810256 8.313948 +3356 709 4 0 10.935580 19.678994 9.619801 +3357 710 6 0 8.580286 -14.501479 3.135425 +3358 710 4 0 8.621343 -14.445805 4.107721 +3359 710 4 0 8.542982 -15.491097 3.062040 +3360 711 6 0 -14.377865 -7.995183 14.343301 +3361 711 4 0 -14.100201 -8.614257 14.993234 +3362 711 4 0 -14.866324 -7.355345 14.871637 +3363 712 6 0 -0.977425 16.774193 13.640180 +3364 712 4 0 -0.958949 17.266593 12.835191 +3365 712 4 0 -1.881684 16.955536 13.931092 +3366 713 6 0 -15.828708 -3.415349 7.406744 +3367 713 4 0 -16.180618 -3.426100 6.520488 +3368 713 4 0 -16.669651 -3.380771 7.995037 +3369 714 6 0 -12.774799 -8.235123 -12.889327 +3370 714 4 0 -12.978669 -7.282136 -13.083792 +3371 714 4 0 -13.615071 -8.678664 -13.235742 +3372 715 6 0 2.845289 0.060180 20.134181 +3373 715 4 0 2.858756 0.453048 19.232311 +3374 715 4 0 1.957136 -0.331348 20.300492 +3375 716 6 0 24.984643 -14.973253 -17.474954 +3376 716 4 0 25.370717 -15.847238 -17.382478 +3377 716 4 0 25.194569 -14.524794 -16.625306 +3378 717 6 0 13.620247 -7.920957 7.008348 +3379 717 4 0 14.470702 -8.278296 6.767655 +3380 717 4 0 13.126236 -7.674429 6.169358 +3381 718 6 0 17.636081 -10.073874 3.386982 +3382 718 4 0 17.376472 -9.849973 2.460148 +3383 718 4 0 17.541385 -10.988029 3.459151 +3384 719 6 0 -23.876026 -12.063687 -5.995846 +3385 719 4 0 -24.585420 -12.252172 -5.420831 +3386 719 4 0 -23.110219 -12.523733 -5.650434 +3387 720 6 0 -23.535607 1.699271 1.932031 +3388 720 4 0 -24.143027 1.031548 1.814474 +3389 720 4 0 -23.866587 2.338510 2.606284 +3390 721 6 0 13.720565 9.351789 12.307976 +3391 721 4 0 13.899370 10.225405 12.040604 +3392 721 4 0 13.192298 9.477241 13.121209 +3393 722 6 0 15.291476 15.170550 12.140656 +3394 722 4 0 14.287956 15.135496 12.069067 +3395 722 4 0 15.572140 14.570493 11.432982 +3396 723 6 0 -10.060226 -11.465180 13.094454 +3397 723 4 0 -9.757397 -11.240849 13.961157 +3398 723 4 0 -9.428065 -11.417927 12.436211 +3399 724 6 0 -19.840622 -4.281655 -17.053557 +3400 724 4 0 -20.444679 -3.559033 -16.740868 +3401 724 4 0 -20.093102 -5.062268 -16.449961 +3402 725 6 0 -11.088232 19.299933 12.989268 +3403 725 4 0 -11.278861 18.327556 12.943710 +3404 725 4 0 -10.555994 19.370336 13.806383 +3405 726 6 0 14.192836 -14.527612 16.897429 +3406 726 4 0 13.394071 -15.012895 17.049022 +3407 726 4 0 14.074952 -14.064189 16.039244 +3408 727 6 0 5.078670 -4.434084 15.727807 +3409 727 4 0 5.834022 -4.419315 16.349614 +3410 727 4 0 5.405954 -4.558925 14.872493 +3411 728 6 0 -19.510762 -4.936357 -8.682052 +3412 728 4 0 -18.583830 -4.871299 -8.739257 +3413 728 4 0 -19.725350 -4.373920 -7.917441 +3414 729 6 0 6.637127 -10.197837 -8.914867 +3415 729 4 0 7.303561 -10.846941 -9.129195 +3416 729 4 0 7.018008 -9.736820 -8.200293 +3417 730 6 0 -23.721355 20.227172 -16.438294 +3418 730 4 0 -24.533045 20.118818 -15.892499 +3419 730 4 0 -24.022901 20.350741 -17.335304 +3420 731 6 0 -0.030599 -15.820284 7.354097 +3421 731 4 0 -0.675125 -15.374015 6.761895 +3422 731 4 0 -0.583629 -16.217933 8.065590 +3423 732 6 0 17.878609 -6.751885 -17.518842 +3424 732 4 0 17.903391 -7.334049 -16.742820 +3425 732 4 0 17.140042 -7.214968 -18.038372 +3426 733 6 0 -5.849569 3.309930 19.753024 +3427 733 4 0 -6.252138 4.072448 20.161965 +3428 733 4 0 -5.149208 3.038493 20.337689 +3429 734 6 0 -24.710885 -6.308647 13.490216 +3430 734 4 0 -25.586238 -6.177846 13.106753 +3431 734 4 0 -24.889314 -6.461576 14.430169 +3432 735 6 0 -11.604329 -16.031249 -0.237137 +3433 735 4 0 -10.966421 -16.304157 -0.881127 +3434 735 4 0 -11.170811 -15.476610 0.378509 +3435 736 6 0 21.103321 -18.752766 6.405335 +3436 736 4 0 21.283349 -17.950114 6.943720 +3437 736 4 0 21.235391 -18.472219 5.506239 +3438 737 6 0 -0.369145 -20.712312 19.095306 +3439 737 4 0 0.355231 -20.367028 19.676247 +3440 737 4 0 -1.186977 -20.260183 19.421119 +3441 738 6 0 13.869578 -2.965624 18.758945 +3442 738 4 0 13.547281 -3.390529 19.570053 +3443 738 4 0 14.278344 -2.158860 19.065428 +3444 739 6 0 -15.806264 2.737988 -2.216704 +3445 739 4 0 -16.485177 2.180539 -1.805532 +3446 739 4 0 -15.814791 2.396599 -3.131246 +3447 740 6 0 -11.766416 -8.088239 8.837485 +3448 740 4 0 -11.812419 -8.926527 9.226533 +3449 740 4 0 -12.558194 -7.583042 9.186828 +3450 741 6 0 23.076788 16.678629 12.104295 +3451 741 4 0 23.468754 16.241536 11.310898 +3452 741 4 0 22.132874 16.713960 11.904816 +3453 742 6 0 -14.202464 -15.765503 -5.593495 +3454 742 4 0 -14.871838 -15.026911 -5.676361 +3455 742 4 0 -13.955401 -15.992753 -6.481500 +3456 743 6 0 15.150303 11.672770 19.298045 +3457 743 4 0 15.470730 12.261881 18.627217 +3458 743 4 0 15.518028 11.969931 20.141796 +3459 744 6 0 9.848503 -12.101587 -10.529245 +3460 744 4 0 10.607536 -11.738045 -10.041608 +3461 744 4 0 9.985842 -11.615457 -11.376399 +3462 745 6 0 2.125570 -11.875883 -16.645987 +3463 745 4 0 2.047554 -12.712083 -16.165814 +3464 745 4 0 2.067413 -12.170151 -17.579365 +3465 746 6 0 -5.977611 10.651495 7.046682 +3466 746 4 0 -5.213541 10.455986 7.620137 +3467 746 4 0 -6.494562 9.846985 7.169759 +3468 747 6 0 -16.351535 -7.485266 -9.424947 +3469 747 4 0 -16.745079 -6.668906 -9.070767 +3470 747 4 0 -16.602332 -8.158689 -8.798627 +3471 748 6 0 24.296678 -17.192464 4.785797 +3472 748 4 0 24.587865 -18.035334 5.123313 +3473 748 4 0 24.068802 -16.574501 5.523851 +3474 749 6 0 -10.968856 -18.323021 -8.138707 +3475 749 4 0 -11.363544 -18.853138 -8.863013 +3476 749 4 0 -10.206142 -17.988660 -8.562061 +3477 750 6 0 -9.854962 -9.956148 -15.278228 +3478 750 4 0 -10.293465 -9.897483 -14.451993 +3479 750 4 0 -9.970473 -10.887047 -15.573043 +3480 751 6 0 -2.935483 6.363032 -19.045018 +3481 751 4 0 -3.535132 5.588364 -18.854687 +3482 751 4 0 -3.494550 7.145960 -19.014910 +3483 752 6 0 5.112400 17.701587 -11.443651 +3484 752 4 0 5.575170 17.705031 -12.266361 +3485 752 4 0 5.677404 18.265335 -10.960537 +3486 753 6 0 -6.450118 17.009140 6.526693 +3487 753 4 0 -6.743394 16.108032 6.566324 +3488 753 4 0 -5.677664 17.076672 5.879731 +3489 754 6 0 13.801680 -10.581422 -18.444834 +3490 754 4 0 14.024633 -10.709852 -17.519503 +3491 754 4 0 14.526918 -10.713699 -19.015218 +3492 755 6 0 -26.491618 -8.486894 -15.884962 +3493 755 4 0 -26.227094 -9.167912 -16.481603 +3494 755 4 0 -27.254427 -8.747438 -15.427464 +3495 756 6 0 9.041006 -18.956744 11.010081 +3496 756 4 0 9.242427 -19.133960 10.087876 +3497 756 4 0 9.841718 -19.136012 11.534074 +3498 757 6 0 -14.427557 4.070601 -15.330760 +3499 757 4 0 -14.952347 4.033207 -14.554014 +3500 757 4 0 -14.812926 4.741427 -15.800456 +3501 758 6 0 17.060580 -3.941095 -20.977244 +3502 758 4 0 17.749250 -4.204310 -20.329442 +3503 758 4 0 16.300042 -3.942896 -20.427486 +3504 759 6 0 -23.014194 6.362529 14.192538 +3505 759 4 0 -23.324814 5.470443 14.451595 +3506 759 4 0 -22.082482 6.279068 14.241974 +3507 760 6 0 -25.628726 -6.961569 -2.257843 +3508 760 4 0 -25.574604 -7.184504 -1.341207 +3509 760 4 0 -26.582064 -6.786831 -2.353726 +3510 761 6 0 22.564240 2.932310 -9.807597 +3511 761 4 0 23.151969 3.604785 -10.163343 +3512 761 4 0 22.874635 2.102350 -10.219491 +3513 762 6 0 -3.253479 19.088800 -17.106412 +3514 762 4 0 -2.788864 19.318234 -16.243589 +3515 762 4 0 -2.764381 19.537649 -17.806531 +3516 763 6 0 -22.859061 13.661040 -17.687912 +3517 763 4 0 -22.818174 13.783386 -16.772102 +3518 763 4 0 -23.770832 13.543351 -17.918472 +3519 764 6 0 9.494782 -11.734449 -13.112549 +3520 764 4 0 8.961400 -12.465267 -13.446468 +3521 764 4 0 9.761388 -11.207603 -13.875868 +3522 765 6 0 -23.688259 3.132799 -17.827915 +3523 765 4 0 -24.125760 3.978960 -17.963214 +3524 765 4 0 -22.830341 3.138251 -18.271402 +3525 766 6 0 2.139153 19.832776 -5.462308 +3526 766 4 0 3.092901 19.927439 -5.794969 +3527 766 4 0 1.766619 18.977669 -5.658347 +3528 767 6 0 -18.034230 16.770127 14.099225 +3529 767 4 0 -17.902225 17.120236 14.993829 +3530 767 4 0 -17.676323 15.854045 14.106616 +3531 768 6 0 1.824513 11.181132 6.084313 +3532 768 4 0 1.685221 10.344866 6.529341 +3533 768 4 0 1.455718 11.848001 6.661967 +3534 769 6 0 -11.843291 -5.056449 -16.641604 +3535 769 4 0 -12.501020 -5.242103 -17.328702 +3536 769 4 0 -12.014281 -5.753377 -15.968200 +3537 770 6 0 -22.854164 5.542584 7.008128 +3538 770 4 0 -23.145262 4.706955 7.372586 +3539 770 4 0 -23.371620 6.215233 7.454255 +3540 771 6 0 15.073774 -20.411976 -0.392431 +3541 771 4 0 14.408322 -20.469017 0.286083 +3542 771 4 0 14.632572 -19.889979 -1.049199 +3543 772 6 0 -17.960070 -5.852749 5.689988 +3544 772 4 0 -18.090795 -5.039390 5.186397 +3545 772 4 0 -18.353234 -5.775538 6.579834 +3546 773 6 0 -15.352248 -19.036717 0.344261 +3547 773 4 0 -15.093308 -18.197320 -0.050384 +3548 773 4 0 -15.225898 -18.950231 1.302869 +3549 774 6 0 18.470960 -18.740483 5.244443 +3550 774 4 0 18.242618 -17.821184 5.079689 +3551 774 4 0 19.343394 -18.632602 5.657266 +3552 775 6 0 -20.494949 -15.508798 0.415196 +3553 775 4 0 -21.033257 -14.800381 0.873351 +3554 775 4 0 -20.631551 -16.381502 0.919462 +3555 776 6 0 -26.836213 -15.820962 -1.291434 +3556 776 4 0 -25.922353 -15.963173 -1.047747 +3557 776 4 0 -27.438259 -16.224400 -0.574562 +3558 777 6 0 -13.235942 4.403119 -11.675233 +3559 777 4 0 -12.394934 3.955397 -11.762629 +3560 777 4 0 -13.370313 4.660640 -10.729304 +3561 778 6 0 4.457457 8.304220 -12.786971 +3562 778 4 0 3.724242 8.788507 -13.141101 +3563 778 4 0 4.902410 9.007385 -12.278991 +3564 779 6 0 12.905103 9.611740 -9.761522 +3565 779 4 0 12.523788 8.903277 -10.260068 +3566 779 4 0 13.450668 9.299611 -9.028515 +3567 780 6 0 -6.337643 16.236433 1.452793 +3568 780 4 0 -5.424381 16.339480 1.573225 +3569 780 4 0 -6.667968 16.644895 2.291271 +3570 781 6 0 26.439116 -1.915810 -20.713552 +3571 781 4 0 27.188632 -1.287536 -20.817388 +3572 781 4 0 26.782485 -2.730706 -20.995261 +3573 782 6 0 -19.182622 4.092355 9.034920 +3574 782 4 0 -19.485362 4.670885 8.308243 +3575 782 4 0 -20.013187 3.814515 9.521856 +3576 783 6 0 -2.300541 3.557512 -14.043398 +3577 783 4 0 -1.431422 3.599599 -13.555115 +3578 783 4 0 -1.988145 3.224630 -14.961052 +3579 784 6 0 -6.670819 -15.218721 -14.514642 +3580 784 4 0 -6.017795 -15.980959 -14.424699 +3581 784 4 0 -6.265671 -14.423752 -14.172913 +3582 785 6 0 24.507006 4.960415 18.725868 +3583 785 4 0 24.051892 4.202462 19.172938 +3584 785 4 0 23.940639 5.744203 18.851669 +3585 786 6 0 24.049293 12.473043 -13.141226 +3586 786 4 0 23.243912 12.962673 -12.967339 +3587 786 4 0 23.840443 11.608716 -13.489633 +3588 787 6 0 -14.826342 -14.174711 -1.101280 +3589 787 4 0 -14.425942 -14.926791 -0.673989 +3590 787 4 0 -15.768151 -14.488595 -1.118329 +3591 788 6 0 11.933486 13.553808 -14.961215 +3592 788 4 0 11.036396 13.817670 -14.752407 +3593 788 4 0 12.216429 12.950104 -14.279104 +3594 789 6 0 -2.797562 -12.367574 -0.515800 +3595 789 4 0 -3.179634 -11.713519 0.050158 +3596 789 4 0 -1.854871 -12.532942 -0.270880 +3597 790 6 0 17.488207 19.028545 -2.724709 +3598 790 4 0 17.501182 19.646316 -1.945319 +3599 790 4 0 17.260989 19.579570 -3.517708 +3600 791 6 0 -8.757369 -14.229883 -8.206010 +3601 791 4 0 -8.893000 -13.537739 -8.862015 +3602 791 4 0 -9.392123 -14.135387 -7.486682 +3603 792 6 0 -19.153579 -12.365172 5.625409 +3604 792 4 0 -19.433383 -12.590110 4.725475 +3605 792 4 0 -19.595557 -11.555979 5.869535 +3606 793 6 0 -7.701926 -16.135625 -11.737971 +3607 793 4 0 -6.868196 -16.044745 -12.240387 +3608 793 4 0 -8.301809 -15.535544 -12.265120 +3609 794 6 0 -3.605808 12.358960 20.023921 +3610 794 4 0 -4.119307 12.832959 19.358309 +3611 794 4 0 -4.145218 11.656406 20.372183 +3612 795 6 0 -13.013980 18.377636 -12.951904 +3613 795 4 0 -12.288179 17.997337 -13.504982 +3614 795 4 0 -12.538318 18.992103 -12.385350 +3615 796 6 0 -1.385735 6.480272 7.505236 +3616 796 4 0 -1.829939 5.594981 7.333987 +3617 796 4 0 -1.326794 6.575998 8.446333 +3618 797 6 0 9.907861 10.609361 -15.151767 +3619 797 4 0 10.299023 10.375476 -14.276851 +3620 797 4 0 9.651161 11.529891 -14.985274 +3621 798 6 0 9.310538 -2.514250 -12.134416 +3622 798 4 0 10.198177 -2.553660 -11.653872 +3623 798 4 0 8.836792 -1.753472 -11.726830 +3624 799 6 0 -21.580142 4.778390 0.032360 +3625 799 4 0 -21.344591 5.531473 -0.492439 +3626 799 4 0 -20.893065 4.098475 -0.015753 +3627 800 6 0 -19.278441 10.667329 -7.670184 +3628 800 4 0 -19.734646 10.867025 -6.871193 +3629 800 4 0 -18.532328 10.061861 -7.412248 +3630 801 6 0 15.203902 17.401580 19.186703 +3631 801 4 0 15.570898 16.998223 18.309293 +3632 801 4 0 14.252264 17.471997 19.020983 +3633 802 6 0 17.475659 -4.241820 15.422666 +3634 802 4 0 17.040898 -4.071975 16.320909 +3635 802 4 0 18.352897 -4.517345 15.720235 +3636 803 6 0 26.262986 8.204965 -20.205701 +3637 803 4 0 26.293506 8.464866 -19.242230 +3638 803 4 0 25.312183 8.095575 -20.318886 +3639 804 6 0 0.327844 9.896832 15.417356 +3640 804 4 0 1.202524 9.685899 15.170065 +3641 804 4 0 -0.168717 9.349803 14.747140 +3642 805 6 0 13.450972 -1.248355 9.296159 +3643 805 4 0 12.530981 -1.651940 9.252801 +3644 805 4 0 13.953341 -1.912001 9.787602 +3645 806 6 0 -5.429467 -15.995612 -8.899753 +3646 806 4 0 -4.916725 -16.325409 -8.062672 +3647 806 4 0 -6.362549 -16.264748 -8.759990 +3648 807 6 0 -17.910357 -1.868084 -15.474085 +3649 807 4 0 -18.801800 -2.365773 -15.300107 +3650 807 4 0 -17.939036 -0.883951 -15.233581 +3651 808 6 0 -6.998449 17.854546 12.155260 +3652 808 4 0 -7.324766 18.684261 11.705842 +3653 808 4 0 -7.250338 17.940958 13.056006 +3654 809 6 0 -27.017579 -12.852914 -7.744953 +3655 809 4 0 -26.095216 -13.088941 -7.541719 +3656 809 4 0 -27.046015 -11.903607 -7.742366 +3657 810 6 0 -20.992952 2.770137 13.223137 +3658 810 4 0 -21.230776 2.404263 14.087077 +3659 810 4 0 -20.235470 2.326081 12.930982 +3660 811 6 0 -26.544599 -5.877011 11.453664 +3661 811 4 0 -26.990332 -6.544246 10.916058 +3662 811 4 0 -26.022394 -5.435999 10.830265 +3663 812 6 0 -18.806379 11.367507 -13.046200 +3664 812 4 0 -19.789015 11.313553 -13.067429 +3665 812 4 0 -18.628129 11.249318 -14.024506 +3666 813 6 0 24.794642 -2.429791 16.906929 +3667 813 4 0 24.375084 -1.564983 16.998802 +3668 813 4 0 24.946627 -2.558178 15.958491 +3669 814 6 0 -5.039569 8.056593 -19.064906 +3670 814 4 0 -5.052461 7.958795 -18.117466 +3671 814 4 0 -5.966890 7.849304 -19.446709 +3672 815 6 0 -2.889572 19.346856 10.223639 +3673 815 4 0 -3.384312 19.390763 9.401856 +3674 815 4 0 -2.683383 20.308050 10.287170 +3675 816 6 0 24.834396 15.890694 6.130456 +3676 816 4 0 24.234322 16.328808 6.788069 +3677 816 4 0 24.458399 16.070054 5.248361 +3678 817 6 0 -5.675815 -18.202610 8.635402 +3679 817 4 0 -5.773224 -18.994730 9.253066 +3680 817 4 0 -6.566693 -17.951332 8.462469 +3681 818 6 0 0.200228 10.638735 -9.720146 +3682 818 4 0 1.124053 10.363079 -9.765946 +3683 818 4 0 -0.169388 10.758518 -8.862327 +3684 819 6 0 12.586551 -8.995486 13.235948 +3685 819 4 0 11.738414 -8.465169 13.179917 +3686 819 4 0 13.275714 -8.448558 12.911108 +3687 820 6 0 21.728995 -9.340509 14.117203 +3688 820 4 0 21.166035 -8.543859 14.159733 +3689 820 4 0 21.300249 -10.103143 14.587027 +3690 821 6 0 -6.837755 -7.061822 -14.579566 +3691 821 4 0 -7.451539 -6.737549 -13.910594 +3692 821 4 0 -7.310401 -7.496795 -15.364575 +3693 822 6 0 -9.354286 -10.670675 -5.815047 +3694 822 4 0 -9.142443 -9.961054 -6.416990 +3695 822 4 0 -10.107132 -10.315463 -5.251791 +3696 823 6 0 -8.705352 0.316369 14.356920 +3697 823 4 0 -8.755318 1.248673 14.182151 +3698 823 4 0 -7.817961 -0.022395 14.313721 +3699 824 6 0 14.343736 18.982116 -1.699643 +3700 824 4 0 14.409424 19.286931 -2.586247 +3701 824 4 0 14.592964 19.709765 -1.190359 +3702 825 6 0 14.559527 1.138316 10.218417 +3703 825 4 0 15.479051 1.159830 9.856479 +3704 825 4 0 14.063855 0.416501 9.816078 +3705 826 6 0 -20.566241 -0.996254 13.005878 +3706 826 4 0 -20.899331 -1.479928 12.209922 +3707 826 4 0 -20.624473 -1.700653 13.673656 +3708 827 6 0 -12.852778 -16.278261 -7.915385 +3709 827 4 0 -13.264438 -16.542888 -8.750067 +3710 827 4 0 -12.112512 -16.948829 -7.782415 +3711 828 6 0 -25.785944 -19.319619 -1.839096 +3712 828 4 0 -26.458799 -18.855500 -2.342721 +3713 828 4 0 -25.985807 -19.145409 -0.929325 +3714 829 6 0 -10.186107 18.619821 1.502896 +3715 829 4 0 -10.024101 19.020438 2.390188 +3716 829 4 0 -10.942245 19.107400 1.164289 +3717 830 6 0 4.484858 10.819107 -17.964431 +3718 830 4 0 5.133939 11.386899 -18.298672 +3719 830 4 0 4.527691 10.727124 -17.013873 +3720 831 6 0 6.463933 -18.890881 -12.906574 +3721 831 4 0 7.142489 -18.893949 -12.181472 +3722 831 4 0 6.490763 -19.813219 -13.109192 +3723 832 6 0 -15.198788 -16.766626 -9.336110 +3724 832 4 0 -15.377180 -16.563167 -8.461513 +3725 832 4 0 -15.323254 -15.974257 -9.877497 +3726 833 6 0 -14.146010 -20.422548 8.878122 +3727 833 4 0 -14.236979 -20.532175 7.917793 +3728 833 4 0 -13.662828 -21.215449 9.131232 +3729 834 6 0 0.614957 1.428020 12.956126 +3730 834 4 0 -0.110540 1.901658 12.528670 +3731 834 4 0 0.325279 0.716474 13.497208 +3732 835 6 0 -22.321257 -12.194484 -18.427855 +3733 835 4 0 -22.696325 -13.106322 -18.375252 +3734 835 4 0 -22.412389 -11.917225 -19.335761 +3735 836 6 0 12.531442 -4.758462 20.472899 +3736 836 4 0 13.067534 -4.753926 21.307738 +3737 836 4 0 12.096556 -5.562360 20.454035 +3738 837 6 0 13.892356 14.515119 -17.220006 +3739 837 4 0 13.491013 15.249793 -17.676248 +3740 837 4 0 14.027899 14.819402 -16.306112 +3741 838 6 0 17.502120 -14.847049 -15.435947 +3742 838 4 0 17.364472 -13.948352 -15.811879 +3743 838 4 0 18.105027 -15.359005 -16.059699 +3744 839 6 0 -0.502268 9.530205 -15.562269 +3745 839 4 0 -0.938753 10.373293 -15.281955 +3746 839 4 0 -0.097702 9.138998 -14.755615 +3747 840 6 0 -21.309309 -20.408905 -16.987522 +3748 840 4 0 -21.345337 -20.375840 -17.999142 +3749 840 4 0 -22.141862 -20.762308 -16.688786 +3750 841 6 0 22.147493 -6.639909 2.885000 +3751 841 4 0 22.188652 -7.549798 2.578098 +3752 841 4 0 22.107229 -6.728348 3.871637 +3753 842 6 0 -9.687279 5.414380 15.613331 +3754 842 4 0 -9.782742 5.066486 16.529208 +3755 842 4 0 -10.448969 5.923644 15.361474 +3756 843 6 0 5.675344 7.586899 16.980957 +3757 843 4 0 5.258959 7.810456 16.122506 +3758 843 4 0 6.513311 8.070410 16.991766 +3759 844 6 0 -20.413973 -2.810756 -14.704675 +3760 844 4 0 -20.680710 -3.455276 -14.087899 +3761 844 4 0 -20.927913 -2.006038 -14.605374 +3762 845 6 0 -22.235897 -8.299273 -7.619662 +3763 845 4 0 -22.889194 -7.882281 -8.261122 +3764 845 4 0 -22.332627 -7.861076 -6.765324 +3765 846 6 0 -23.981218 -0.704780 -9.514827 +3766 846 4 0 -24.783483 -0.715849 -8.978342 +3767 846 4 0 -24.016239 0.147898 -9.927153 +3768 847 6 0 7.651613 1.583143 -14.760840 +3769 847 4 0 8.495812 1.439050 -15.299970 +3770 847 4 0 7.511620 2.516131 -14.862425 +3771 848 6 0 0.884173 -19.810112 -4.062624 +3772 848 4 0 1.292889 -20.586437 -4.551786 +3773 848 4 0 1.192078 -19.022801 -4.536111 +3774 849 6 0 7.412040 11.115702 19.231433 +3775 849 4 0 7.538580 12.059258 19.246795 +3776 849 4 0 8.260401 10.691591 19.301522 +3777 850 6 0 -11.204219 12.495567 -4.600276 +3778 850 4 0 -11.028750 12.509428 -5.556334 +3779 850 4 0 -10.363635 12.791820 -4.218009 +3780 851 6 0 -25.903206 -8.385161 -5.723268 +3781 851 4 0 -25.119970 -7.920015 -6.092411 +3782 851 4 0 -25.526651 -8.874179 -5.022568 +3783 852 6 0 14.802024 4.590987 3.933454 +3784 852 4 0 14.375737 4.043905 3.277970 +3785 852 4 0 15.659394 4.916121 3.578549 +3786 853 6 0 -15.934931 6.397950 6.388644 +3787 853 4 0 -15.620802 7.216906 6.047813 +3788 853 4 0 -15.636175 5.690485 5.842853 +3789 854 6 0 22.212269 -3.912264 -1.134049 +3790 854 4 0 22.458591 -3.040474 -1.407870 +3791 854 4 0 22.479085 -3.998208 -0.233468 +3792 855 6 0 4.448770 -18.623307 6.143091 +3793 855 4 0 3.859811 -18.031485 6.593889 +3794 855 4 0 4.151476 -19.464236 6.536017 +3795 856 6 0 12.429816 -18.121512 9.248186 +3796 856 4 0 11.629942 -18.388099 8.814270 +3797 856 4 0 12.215561 -17.727680 10.120763 +3798 857 6 0 -8.497823 15.258872 16.966673 +3799 857 4 0 -7.810852 14.986731 16.348784 +3800 857 4 0 -8.167882 16.114306 17.249722 +3801 858 6 0 -20.878291 -14.745638 19.779655 +3802 858 4 0 -20.112590 -15.386225 19.796245 +3803 858 4 0 -20.957585 -14.429386 20.699068 +3804 859 6 0 -8.042069 13.212107 -6.799126 +3805 859 4 0 -7.666844 14.065367 -7.020588 +3806 859 4 0 -8.432360 12.994260 -7.617112 +3807 860 6 0 -4.401745 18.792233 12.536049 +3808 860 4 0 -5.252264 18.441661 12.206342 +3809 860 4 0 -3.786314 18.658531 11.783750 +3810 861 6 0 -22.502948 12.635671 -9.954592 +3811 861 4 0 -22.382976 11.654218 -10.023557 +3812 861 4 0 -22.588936 12.849370 -9.051340 +3813 862 6 0 6.205019 19.677761 10.016183 +3814 862 4 0 6.418256 20.244108 9.256973 +3815 862 4 0 6.081289 20.311217 10.773751 +3816 863 6 0 21.525435 -20.385383 2.444412 +3817 863 4 0 21.737318 -20.408572 1.494251 +3818 863 4 0 22.084053 -21.109629 2.761837 +3819 864 6 0 -16.599942 -18.820535 17.198669 +3820 864 4 0 -16.278472 -18.736077 16.290240 +3821 864 4 0 -16.380933 -19.763878 17.294110 +3822 865 6 0 -25.290808 -16.946358 -19.688799 +3823 865 4 0 -24.765600 -16.889073 -18.911085 +3824 865 4 0 -25.960541 -16.377910 -19.456590 +3825 866 6 0 -24.694098 -20.476906 -4.136770 +3826 866 4 0 -24.606655 -20.536372 -5.117234 +3827 866 4 0 -25.625806 -20.119370 -3.878957 +3828 867 6 0 11.896824 11.712030 16.306177 +3829 867 4 0 11.348704 12.251154 16.873688 +3830 867 4 0 11.274914 11.545841 15.498058 +3831 868 6 0 5.697623 16.972820 10.470297 +3832 868 4 0 4.991770 17.170798 11.097893 +3833 868 4 0 5.852878 17.817924 10.052784 +3834 869 6 0 -13.284850 -7.746454 -6.025360 +3835 869 4 0 -12.994189 -6.883337 -5.651840 +3836 869 4 0 -13.328473 -7.609512 -6.952585 +3837 870 6 0 -21.223162 1.160412 -11.807882 +3838 870 4 0 -22.146291 1.276713 -11.566889 +3839 870 4 0 -20.896068 1.043394 -10.863664 +3840 871 6 0 -4.631057 18.622729 -4.921244 +3841 871 4 0 -4.887844 18.863646 -4.031199 +3842 871 4 0 -5.230286 17.969756 -5.219284 +3843 872 6 0 24.681797 -17.654294 -1.670971 +3844 872 4 0 23.768274 -17.475294 -1.329114 +3845 872 4 0 24.791039 -18.602540 -1.565321 +3846 873 6 0 -17.687536 -19.879421 -18.679576 +3847 873 4 0 -17.986562 -20.092647 -17.773622 +3848 873 4 0 -17.222303 -20.676328 -18.924760 +3849 874 6 0 -6.573668 -1.414933 -12.940464 +3850 874 4 0 -5.981594 -0.685726 -13.202528 +3851 874 4 0 -7.313339 -1.430989 -13.600227 +3852 875 6 0 24.852405 8.745112 16.566019 +3853 875 4 0 25.315387 9.320408 17.189845 +3854 875 4 0 25.373490 7.938156 16.494188 +3855 876 6 0 19.231159 -18.894566 -9.451949 +3856 876 4 0 18.429507 -18.461081 -9.748217 +3857 876 4 0 18.920766 -19.499725 -8.784679 +3858 877 6 0 3.338073 -20.229490 -19.454945 +3859 877 4 0 2.656040 -19.781393 -18.876483 +3860 877 4 0 4.028693 -19.592026 -19.519704 +3861 878 6 0 10.225819 20.337141 12.829025 +3862 878 4 0 9.563839 20.833795 13.325284 +3863 878 4 0 9.705679 19.640109 12.367009 +3864 879 6 0 9.533934 0.668964 -16.571520 +3865 879 4 0 10.399193 0.538209 -16.091711 +3866 879 4 0 9.576351 1.385138 -17.298275 +3867 880 6 0 10.662383 -1.197996 9.643694 +3868 880 4 0 10.669217 -0.519470 10.302977 +3869 880 4 0 9.975986 -0.906856 8.995989 +3870 881 6 0 -8.631045 -16.685206 -9.233119 +3871 881 4 0 -8.853335 -15.836492 -8.694578 +3872 881 4 0 -8.361803 -16.344073 -10.088388 +3873 882 6 0 -16.046867 3.202795 -18.808362 +3874 882 4 0 -16.950450 3.324347 -19.009457 +3875 882 4 0 -16.106623 2.648826 -18.004784 +3876 883 6 0 -21.655953 -18.268305 -5.022876 +3877 883 4 0 -22.220521 -18.292491 -4.188932 +3878 883 4 0 -21.437192 -17.347868 -5.235461 +3879 884 6 0 -3.054479 -8.582825 -16.474970 +3880 884 4 0 -3.561388 -8.760643 -15.715699 +3881 884 4 0 -3.058659 -7.559442 -16.547327 +3882 885 6 0 -22.812267 -16.888527 -8.744475 +3883 885 4 0 -22.235942 -16.090582 -8.825879 +3884 885 4 0 -23.719738 -16.520887 -8.878128 +3885 886 6 0 -3.704190 -14.195133 -2.407699 +3886 886 4 0 -3.387102 -14.174810 -3.288821 +3887 886 4 0 -3.356349 -13.453995 -1.933962 +3888 887 6 0 -20.696165 -13.591009 17.258237 +3889 887 4 0 -21.475297 -13.153296 16.960866 +3890 887 4 0 -20.768473 -13.524910 18.211894 +3891 888 6 0 -18.077515 8.036142 -4.047377 +3892 888 4 0 -17.812789 8.648744 -4.737838 +3893 888 4 0 -17.620887 8.520879 -3.289746 +3894 889 6 0 -20.110600 19.407267 6.124785 +3895 889 4 0 -20.896902 18.868688 6.157232 +3896 889 4 0 -20.402600 20.334320 6.077069 +3897 890 6 0 -2.051195 9.467924 7.827905 +3898 890 4 0 -2.097838 10.162479 7.064246 +3899 890 4 0 -2.844983 9.344092 8.305687 +3900 891 6 0 -18.682154 5.478699 -2.934427 +3901 891 4 0 -18.229636 5.442492 -2.124369 +3902 891 4 0 -18.518659 6.286464 -3.381696 +3903 892 6 0 10.010203 14.447632 13.470001 +3904 892 4 0 10.226696 15.357421 13.799091 +3905 892 4 0 9.262668 14.599091 12.884669 +3906 893 6 0 17.215836 -17.548329 -2.124086 +3907 893 4 0 16.925189 -16.662250 -2.252230 +3908 893 4 0 16.865887 -17.769074 -1.235796 +3909 894 6 0 -5.919183 -9.349524 7.766171 +3910 894 4 0 -6.741218 -8.869400 7.859192 +3911 894 4 0 -5.404573 -8.951408 7.082536 +3912 895 6 0 -10.112774 -17.514245 5.470012 +3913 895 4 0 -10.177248 -17.335797 6.413035 +3914 895 4 0 -10.903396 -17.912916 5.176788 +3915 896 6 0 -17.679442 -12.718669 -9.050443 +3916 896 4 0 -18.270476 -12.557016 -8.300034 +3917 896 4 0 -18.198469 -12.552825 -9.805697 +3918 897 6 0 0.903259 -17.089060 -20.671596 +3919 897 4 0 1.071535 -16.725461 -21.579419 +3920 897 4 0 1.485989 -16.556142 -20.071022 +3921 898 6 0 -1.956506 2.203046 13.006137 +3922 898 4 0 -2.272231 1.835920 13.818085 +3923 898 4 0 -1.592679 3.074581 13.177858 +3924 899 6 0 24.307317 -7.931160 13.942533 +3925 899 4 0 23.816648 -8.756525 14.130421 +3926 899 4 0 25.262169 -8.082231 14.204005 +3927 900 6 0 -14.058968 19.300765 0.314297 +3928 900 4 0 -13.917031 18.387642 0.266006 +3929 900 4 0 -13.221511 19.754514 0.415523 +3930 901 6 0 -16.676872 -9.877858 -20.319129 +3931 901 4 0 -17.274810 -10.519927 -20.729021 +3932 901 4 0 -16.941519 -8.964879 -20.646570 +3933 902 6 0 -12.680702 -6.911233 16.978199 +3934 902 4 0 -13.557850 -6.922758 17.425905 +3935 902 4 0 -12.269134 -7.738029 17.145620 +3936 903 6 0 19.555509 -17.579926 -19.976313 +3937 903 4 0 19.050335 -18.389167 -19.640518 +3938 903 4 0 18.949443 -17.119931 -20.527020 +3939 904 6 0 21.076471 3.084534 14.949703 +3940 904 4 0 21.982711 3.424585 15.137726 +3941 904 4 0 21.059338 2.943234 13.989445 +3942 905 6 0 16.442213 12.147725 -13.378964 +3943 905 4 0 16.950297 12.610197 -12.695317 +3944 905 4 0 15.827762 12.795203 -13.746701 +3945 906 6 0 -25.439902 4.711302 -20.157995 +3946 906 4 0 -25.232468 3.814757 -20.523590 +3947 906 4 0 -26.313293 4.971364 -20.426324 +3948 907 6 0 -7.588528 12.088664 13.408162 +3949 907 4 0 -8.200423 12.174754 12.658025 +3950 907 4 0 -8.113691 11.630720 14.142990 +3951 908 6 0 26.436785 0.034911 5.586573 +3952 908 4 0 25.457878 0.386547 5.643112 +3953 908 4 0 26.282513 -0.892272 5.901143 +3954 909 6 0 20.823937 -7.100912 -0.564869 +3955 909 4 0 20.884805 -6.179294 -0.203608 +3956 909 4 0 21.513466 -7.607628 -0.095760 +3957 910 6 0 12.691400 17.480587 1.380786 +3958 910 4 0 12.692396 17.261428 2.322353 +3959 910 4 0 12.611923 16.651984 0.923905 +3960 911 6 0 -24.911725 10.197954 8.411953 +3961 911 4 0 -25.636701 10.762551 8.096402 +3962 911 4 0 -25.071847 10.060147 9.332683 +3963 912 6 0 -18.639378 5.447813 -18.001661 +3964 912 4 0 -18.974361 6.320483 -18.277153 +3965 912 4 0 -17.987263 5.631149 -17.283273 +3966 913 6 0 -20.959865 -1.961151 19.496385 +3967 913 4 0 -20.534023 -2.468481 20.215248 +3968 913 4 0 -20.355179 -1.361709 19.053432 +3969 914 6 0 25.098062 -12.896695 17.002170 +3970 914 4 0 24.406639 -13.455503 17.206622 +3971 914 4 0 24.932322 -12.540708 16.110034 +3972 915 6 0 -26.490917 -20.588542 6.528398 +3973 915 4 0 -26.917008 -20.096913 5.823633 +3974 915 4 0 -25.946103 -19.813146 6.884354 +3975 916 6 0 18.663882 -15.761448 0.434559 +3976 916 4 0 18.293356 -16.602715 0.618971 +3977 916 4 0 18.164755 -15.050245 0.892557 +3978 917 6 0 10.988074 -12.207500 15.456319 +3979 917 4 0 11.659991 -12.535619 14.945024 +3980 917 4 0 11.316489 -11.864883 16.268157 +3981 918 6 0 -21.505805 3.757682 10.585783 +3982 918 4 0 -21.516645 3.500786 11.561155 +3983 918 4 0 -21.430683 4.736521 10.599986 +3984 919 6 0 12.282284 -13.106227 -18.881930 +3985 919 4 0 12.759593 -12.281589 -18.973554 +3986 919 4 0 11.656222 -12.946682 -18.168338 +3987 920 6 0 13.087944 10.285301 -0.892868 +3988 920 4 0 13.800763 10.058844 -0.348329 +3989 920 4 0 13.444993 10.532975 -1.717057 +3990 921 6 0 -9.162139 -11.933739 -19.558277 +3991 921 4 0 -8.651549 -11.246835 -19.197918 +3992 921 4 0 -8.816392 -12.749175 -19.109531 +3993 922 6 0 -13.431343 12.125781 14.789987 +3994 922 4 0 -14.177333 12.077783 15.386597 +3995 922 4 0 -13.089871 13.025037 14.836795 +3996 923 6 0 18.177368 7.215321 -17.740007 +3997 923 4 0 17.389540 7.853045 -17.679076 +3998 923 4 0 17.843221 6.367105 -17.888163 +3999 924 6 0 1.466167 -13.601298 7.582198 +4000 924 4 0 0.972435 -14.385853 7.776388 +4001 924 4 0 0.919057 -12.873156 7.164133 +4002 925 6 0 11.325663 12.317782 -17.859494 +4003 925 4 0 11.786996 12.918180 -17.243704 +4004 925 4 0 11.714407 11.538450 -17.534509 +4005 926 6 0 17.972713 -1.451543 -17.483151 +4006 926 4 0 18.207855 -0.912662 -18.203981 +4007 926 4 0 17.842338 -0.769611 -16.779012 +4008 927 6 0 25.598333 7.442585 -7.896359 +4009 927 4 0 25.893540 7.973241 -8.686847 +4010 927 4 0 24.662621 7.579298 -7.748832 +4011 928 6 0 16.953262 -5.516556 7.796955 +4012 928 4 0 16.150883 -6.127947 7.920888 +4013 928 4 0 16.872953 -4.676742 8.219748 +4014 929 6 0 12.447806 -2.742404 -5.103683 +4015 929 4 0 13.262065 -2.337192 -4.865615 +4016 929 4 0 12.567802 -3.638206 -5.489980 +4017 930 6 0 23.442824 1.912863 -4.186751 +4018 930 4 0 22.783687 1.609227 -4.831788 +4019 930 4 0 23.692291 2.783304 -4.548967 +4020 931 6 0 26.613065 -7.057291 -2.847144 +4021 931 4 0 25.921057 -6.884909 -2.189136 +4022 931 4 0 26.624480 -6.286981 -3.475448 +4023 932 6 0 -10.239445 -6.332791 -18.742073 +4024 932 4 0 -10.340169 -5.647767 -18.098924 +4025 932 4 0 -10.090969 -5.968696 -19.646250 +4026 933 6 0 -20.376403 -6.492157 -15.200035 +4027 933 4 0 -21.216096 -6.709010 -14.741818 +4028 933 4 0 -19.747585 -6.443291 -14.454302 +4029 934 6 0 12.425316 -12.073259 9.372568 +4030 934 4 0 12.595386 -11.730652 10.279050 +4031 934 4 0 11.975580 -11.375801 8.874658 +4032 935 6 0 -8.532199 -0.531892 16.952480 +4033 935 4 0 -8.680978 0.164546 17.584693 +4034 935 4 0 -8.601294 -0.093174 16.091071 +4035 936 6 0 -15.814683 -10.863297 -17.898155 +4036 936 4 0 -15.883461 -10.639190 -18.879894 +4037 936 4 0 -16.703278 -10.849248 -17.497731 +4038 937 6 0 -14.449801 9.759702 -12.925291 +4039 937 4 0 -14.272437 8.788361 -12.976539 +4040 937 4 0 -15.016657 9.891030 -12.180657 +4041 938 6 0 -21.430732 11.921106 -19.181002 +4042 938 4 0 -21.526880 12.138660 -20.109451 +4043 938 4 0 -22.050688 12.479567 -18.617821 +4044 939 6 0 -25.974066 -3.158098 2.462777 +4045 939 4 0 -25.831369 -2.255405 2.174801 +4046 939 4 0 -26.439926 -3.064742 3.263507 +4047 940 6 0 -3.706735 6.147388 -13.605663 +4048 940 4 0 -3.297323 5.307884 -13.886877 +4049 940 4 0 -3.422860 6.737980 -14.321183 +4050 941 6 0 -20.883597 16.612287 14.041958 +4051 941 4 0 -20.999564 17.543929 13.958831 +4052 941 4 0 -19.965627 16.487176 14.039107 +4053 942 6 0 -20.557889 -1.845471 7.488592 +4054 942 4 0 -20.340337 -1.068424 6.935483 +4055 942 4 0 -20.903185 -2.604394 7.012639 +4056 943 6 0 -12.460264 -18.929249 4.382660 +4057 943 4 0 -12.282133 -18.769615 3.435033 +4058 943 4 0 -13.389343 -18.666156 4.432821 +4059 944 6 0 1.417248 11.708889 10.582961 +4060 944 4 0 2.296023 11.794703 10.114913 +4061 944 4 0 1.322165 12.680869 10.895877 +4062 945 6 0 10.022181 17.152306 -1.509079 +4063 945 4 0 9.099220 16.788088 -1.473811 +4064 945 4 0 10.556572 16.462293 -1.005697 +4065 946 6 0 26.377298 1.167852 -18.114945 +4066 946 4 0 26.294922 1.597527 -19.017371 +4067 946 4 0 26.810582 1.835218 -17.546811 +4068 947 6 0 4.477282 16.231872 -2.892567 +4069 947 4 0 4.601255 15.878653 -3.817385 +4070 947 4 0 5.378487 16.115183 -2.438618 +4071 948 6 0 24.364511 -2.064551 14.086212 +4072 948 4 0 24.217903 -1.193238 13.665466 +4073 948 4 0 25.144037 -2.400521 13.646565 +4074 949 6 0 19.972396 19.003953 10.129446 +4075 949 4 0 19.099910 19.391464 10.278245 +4076 949 4 0 20.140306 18.289889 10.813702 +4077 950 6 0 -9.744468 15.055459 -16.611544 +4078 950 4 0 -10.467454 15.614656 -16.286228 +4079 950 4 0 -10.073803 14.402676 -17.210684 +4080 951 6 0 -7.338670 -8.956276 -11.936725 +4081 951 4 0 -7.205180 -9.461193 -11.112425 +4082 951 4 0 -8.291268 -8.840677 -12.000288 +4083 952 6 0 9.310332 14.156142 -6.279488 +4084 952 4 0 10.218649 13.951492 -6.545390 +4085 952 4 0 9.258047 14.553265 -5.370592 +4086 953 6 0 0.560208 -13.174622 -9.781962 +4087 953 4 0 0.439761 -12.748376 -10.646076 +4088 953 4 0 0.670280 -14.103731 -9.913873 +4089 954 6 0 26.128167 14.199294 -1.068870 +4090 954 4 0 26.431992 13.452397 -0.460937 +4091 954 4 0 25.201007 14.292566 -1.045597 +4092 955 6 0 -16.949107 1.727945 -4.563937 +4093 955 4 0 -16.652995 1.770027 -5.488123 +4094 955 4 0 -17.803051 2.243334 -4.537865 +4095 956 6 0 -11.599049 -20.904475 0.385428 +4096 956 4 0 -11.617180 -19.974350 0.739051 +4097 956 4 0 -10.733402 -20.802194 -0.016961 +4098 957 6 0 -25.256117 12.394753 17.084014 +4099 957 4 0 -24.597187 12.955531 17.523929 +4100 957 4 0 -25.351341 11.801006 17.816577 +4101 958 6 0 21.083077 10.997597 -6.264609 +4102 958 4 0 20.914438 11.935561 -6.410001 +4103 958 4 0 20.611065 10.573853 -6.944918 +4104 959 6 0 24.363484 -19.776402 17.065120 +4105 959 4 0 24.744693 -19.074320 16.551577 +4106 959 4 0 25.036878 -20.294208 17.436608 +4107 960 6 0 -10.735684 9.638082 6.150386 +4108 960 4 0 -10.221167 9.463561 5.360913 +4109 960 4 0 -11.618988 9.902798 5.921573 +4110 961 6 0 -14.186781 2.877388 6.286661 +4111 961 4 0 -14.662769 3.118087 7.092293 +4112 961 4 0 -14.425510 3.607015 5.695311 +4113 962 6 0 23.488790 -12.140879 -16.710373 +4114 962 4 0 23.035645 -11.840916 -17.492726 +4115 962 4 0 24.198140 -11.533887 -16.669370 +4116 963 6 0 -9.756394 20.612891 7.487522 +4117 963 4 0 -10.567829 20.596149 6.941769 +4118 963 4 0 -9.567427 19.672366 7.650269 +4119 964 6 0 -10.809623 -15.325182 16.646046 +4120 964 4 0 -10.540345 -15.380934 15.754906 +4121 964 4 0 -10.995048 -16.212302 17.003558 +4122 965 6 0 23.590175 -14.844140 18.091313 +4123 965 4 0 23.082950 -15.642639 17.817614 +4124 965 4 0 22.918432 -14.433938 18.680116 +4125 966 6 0 -9.843301 16.099124 8.917553 +4126 966 4 0 -10.800912 15.942477 8.746196 +4127 966 4 0 -9.776206 16.007775 9.870062 +4128 967 6 0 -15.969686 15.153089 5.232592 +4129 967 4 0 -15.190596 15.577230 4.796399 +4130 967 4 0 -16.653218 15.791665 5.086615 +4131 968 6 0 -14.522038 4.774109 20.092720 +4132 968 4 0 -13.726552 4.726517 19.600040 +4133 968 4 0 -14.275341 5.232921 20.890928 +4134 969 6 0 -19.150467 -13.472817 -2.000864 +4135 969 4 0 -19.948375 -14.097323 -2.133949 +4136 969 4 0 -18.565882 -13.718795 -2.719742 +4137 970 6 0 26.570568 3.571434 2.677152 +4138 970 4 0 26.009960 3.474978 1.867261 +4139 970 4 0 25.979473 4.132392 3.254985 +4140 971 6 0 2.963742 -20.267378 17.680551 +4141 971 4 0 2.939273 -19.702759 18.451804 +4142 971 4 0 3.704894 -20.009537 17.129551 +4143 972 6 0 12.886914 -16.854820 -15.969948 +4144 972 4 0 13.277380 -15.998244 -16.290560 +4145 972 4 0 12.084202 -16.946569 -16.485310 +4146 973 6 0 -13.403098 20.670706 14.180090 +4147 973 4 0 -12.697115 20.129500 13.825532 +4148 973 4 0 -13.078241 21.562186 14.353615 +4149 974 6 0 1.263724 -2.316623 11.541630 +4150 974 4 0 1.604989 -3.147382 11.057854 +4151 974 4 0 1.301508 -2.419331 12.514250 +4152 975 6 0 16.027424 -2.901060 -7.834089 +4153 975 4 0 15.527925 -3.644628 -8.229138 +4154 975 4 0 15.964477 -2.241942 -8.584411 +4155 976 6 0 20.574908 7.015109 -16.355513 +4156 976 4 0 20.799767 7.912603 -16.672696 +4157 976 4 0 19.614717 7.020855 -16.464707 +4158 977 6 0 -9.799678 -16.315433 -2.735469 +4159 977 4 0 -9.082163 -15.876270 -3.158920 +4160 977 4 0 -9.675027 -17.234496 -2.912849 +4161 978 6 0 19.925358 -1.799248 -13.616500 +4162 978 4 0 19.041533 -1.607762 -13.949745 +4163 978 4 0 20.105803 -1.002750 -13.099573 +4164 979 6 0 26.502531 14.202393 -14.528425 +4165 979 4 0 25.566109 14.188457 -14.685868 +4166 979 4 0 26.586381 14.616670 -13.692642 +4167 980 6 0 -3.640972 -15.964509 3.441932 +4168 980 4 0 -3.916866 -16.633969 4.049731 +4169 980 4 0 -3.180242 -16.493582 2.755249 +4170 981 6 0 20.157853 -15.783144 2.660570 +4171 981 4 0 20.419750 -16.681495 2.950489 +4172 981 4 0 19.984795 -15.805827 1.709836 +4173 982 6 0 3.128568 11.959447 -14.685598 +4174 982 4 0 2.607191 12.662191 -15.102263 +4175 982 4 0 3.769283 12.428495 -14.079944 +4176 983 6 0 -24.815536 -15.542873 4.007555 +4177 983 4 0 -24.218085 -16.000016 3.406953 +4178 983 4 0 -25.315854 -15.091766 3.403899 +4179 984 6 0 19.308952 20.661672 -11.377272 +4180 984 4 0 19.335667 21.503703 -10.905560 +4181 984 4 0 20.214980 20.602723 -11.631713 +4182 985 6 0 13.542822 -5.649499 0.333332 +4183 985 4 0 13.963629 -4.763289 0.274336 +4184 985 4 0 12.814580 -5.810940 -0.269097 +4185 986 6 0 13.690049 -20.143279 -5.943461 +4186 986 4 0 13.436356 -20.544177 -6.811045 +4187 986 4 0 14.540599 -19.746894 -6.080417 +4188 987 6 0 -15.552613 1.765055 -16.570745 +4189 987 4 0 -15.053582 2.345281 -15.988522 +4190 987 4 0 -15.170829 0.889200 -16.752662 +4191 988 6 0 18.304944 6.143260 -6.070829 +4192 988 4 0 18.125046 5.326107 -5.570747 +4193 988 4 0 18.266448 6.784180 -5.360045 +4194 989 6 0 2.506981 -17.274997 10.100766 +4195 989 4 0 3.347828 -17.659592 10.064456 +4196 989 4 0 2.856471 -16.401034 10.442415 +4197 990 6 0 -19.165460 9.947070 1.363209 +4198 990 4 0 -18.730236 10.366229 0.602857 +4199 990 4 0 -18.849961 10.481480 2.151944 +4200 991 6 0 -25.980688 17.933161 -0.316559 +4201 991 4 0 -26.443527 17.228913 -0.781861 +4202 991 4 0 -25.367896 18.145268 -0.998602 +4203 992 6 0 -8.979352 -14.825818 -16.044347 +4204 992 4 0 -8.232685 -15.013438 -15.478412 +4205 992 4 0 -9.593300 -15.565144 -15.856307 +4206 993 6 0 -26.878522 10.651550 -5.997590 +4207 993 4 0 -27.657923 11.080372 -6.414692 +4208 993 4 0 -26.575102 11.315809 -5.418717 +4209 994 6 0 25.946197 20.187421 -17.138659 +4210 994 4 0 26.747885 20.729551 -17.283461 +4211 994 4 0 25.893413 20.171520 -16.172728 +4212 995 6 0 -22.758506 -11.646357 10.203824 +4213 995 4 0 -22.294597 -11.119698 9.558550 +4214 995 4 0 -22.038786 -12.335635 10.328914 +4215 996 6 0 5.051118 -7.506736 -18.096705 +4216 996 4 0 5.890399 -6.995469 -18.089124 +4217 996 4 0 4.432798 -7.081744 -18.676680 +4218 997 6 0 -25.361275 -6.967887 -18.797135 +4219 997 4 0 -24.723765 -6.707007 -18.115496 +4220 997 4 0 -25.259315 -7.901704 -18.865340 +4221 998 6 0 -2.799085 -16.680409 -5.658803 +4222 998 4 0 -3.041668 -16.532466 -4.707237 +4223 998 4 0 -2.655725 -17.646573 -5.729646 +4224 999 6 0 6.961841 -0.650018 14.982518 +4225 999 4 0 7.049840 -0.822572 15.899427 +4226 999 4 0 7.585417 -1.245556 14.495279 +4227 1000 6 0 -27.328225 -2.775920 4.654966 +4228 1000 4 0 -28.131668 -3.256883 4.960696 +4229 1000 4 0 -26.702154 -2.749977 5.390082 +4230 1001 6 0 -10.545176 15.887401 -11.516094 +4231 1001 4 0 -11.354652 16.437925 -11.631152 +4232 1001 4 0 -10.234139 15.573972 -12.408175 +4233 1002 6 0 27.293890 -3.784569 13.095470 +4234 1002 4 0 27.629930 -4.552840 12.571336 +4235 1002 4 0 27.297508 -4.139921 14.014667 +4236 1003 6 0 26.677289 -8.930589 -5.080635 +4237 1003 4 0 27.349144 -8.367067 -5.399678 +4238 1003 4 0 26.178389 -8.423219 -4.437089 +4239 1004 6 0 26.303353 -13.709693 -10.199064 +4240 1004 4 0 26.819339 -13.575870 -11.047002 +4241 1004 4 0 26.995460 -13.448744 -9.504732 +4242 1005 6 0 -5.782538 -6.137070 -18.577558 +4243 1005 4 0 -5.225175 -5.601455 -18.004594 +4244 1005 4 0 -5.277523 -6.828742 -18.969936 +4245 1006 6 0 -10.751593 15.373515 -8.362078 +4246 1006 4 0 -10.116580 15.133048 -9.031534 +4247 1006 4 0 -11.426882 15.817389 -8.872810 +4248 1007 6 0 16.641528 -6.647086 14.042481 +4249 1007 4 0 16.877857 -5.780320 14.352388 +4250 1007 4 0 15.723201 -6.556522 13.694961 +4251 1008 6 0 -9.692102 -20.433174 12.075319 +4252 1008 4 0 -9.015496 -20.798185 11.574612 +4253 1008 4 0 -10.349277 -21.179838 12.030713 +4254 1009 6 0 -3.342987 5.338933 20.099174 +4255 1009 4 0 -3.147711 5.827567 20.954747 +4256 1009 4 0 -4.124775 5.753362 19.736033 +4257 1010 6 0 22.616008 -14.603236 0.953729 +4258 1010 4 0 21.991188 -13.989371 1.394272 +4259 1010 4 0 22.974372 -14.081510 0.229956 +4260 1011 6 0 -8.097592 12.140479 -19.585886 +4261 1011 4 0 -8.453866 12.623380 -20.326053 +4262 1011 4 0 -8.784224 11.654989 -19.152969 +4263 1012 6 0 -21.232297 5.610953 -16.679404 +4264 1012 4 0 -20.585466 5.060918 -17.156512 +4265 1012 4 0 -21.930038 5.836903 -17.294471 +4266 1013 6 0 -10.747633 18.133699 -14.681278 +4267 1013 4 0 -10.847151 18.670752 -15.499579 +4268 1013 4 0 -9.785896 18.213162 -14.415037 +4269 1014 6 0 5.277447 -4.914937 -12.832056 +4270 1014 4 0 4.837973 -4.063025 -13.209955 +4271 1014 4 0 6.186619 -4.697637 -12.711347 +4272 1015 6 0 20.041500 5.021710 -2.968457 +4273 1015 4 0 19.672986 5.469423 -2.234503 +4274 1015 4 0 20.344328 4.132583 -2.637240 +4275 1016 6 0 17.907741 2.778212 -8.037993 +4276 1016 4 0 18.567517 3.366180 -8.410651 +4277 1016 4 0 17.288995 3.302520 -7.441301 +4278 1017 6 0 5.562515 -18.543574 -19.590057 +4279 1017 4 0 6.312662 -18.495893 -20.210476 +4280 1017 4 0 5.830551 -17.824826 -18.960179 +4281 1018 6 0 12.736551 -13.896404 -1.831403 +4282 1018 4 0 12.773597 -12.929037 -1.656141 +4283 1018 4 0 13.175198 -14.041740 -2.708482 +4284 1019 6 0 -4.469179 -3.097942 -13.481704 +4285 1019 4 0 -3.873920 -2.479353 -13.901987 +4286 1019 4 0 -5.276658 -2.695674 -13.122340 +4287 1020 6 0 -21.439043 8.219030 17.863426 +4288 1020 4 0 -21.056703 8.853759 17.338517 +4289 1020 4 0 -21.129569 7.386574 17.512818 +4290 1021 6 0 -20.342022 -7.199464 17.782819 +4291 1021 4 0 -19.811208 -6.577246 18.288787 +4292 1021 4 0 -19.701668 -7.908647 17.571092 +4293 1022 6 0 -14.263922 5.278640 -18.510906 +4294 1022 4 0 -13.564113 4.937165 -17.913388 +4295 1022 4 0 -14.930181 4.580837 -18.615930 +4296 1023 6 0 16.913731 -14.141037 14.480884 +4297 1023 4 0 16.066655 -13.798463 14.461234 +4298 1023 4 0 17.548578 -13.399940 14.431310 +4299 1024 6 0 -25.968088 14.659464 5.007859 +4300 1024 4 0 -25.454004 13.822928 4.891375 +4301 1024 4 0 -26.104124 14.757551 5.974942 +4302 1025 6 0 -18.135969 17.732537 5.080161 +4303 1025 4 0 -18.773193 18.355342 5.390012 +4304 1025 4 0 -18.159466 17.860761 4.093910 +4305 1026 6 0 -27.275820 -16.400609 -7.043757 +4306 1026 4 0 -26.590275 -16.756481 -6.431378 +4307 1026 4 0 -27.617212 -15.617979 -6.640114 +4308 1027 6 0 24.748058 17.280534 18.064239 +4309 1027 4 0 25.308718 17.915370 18.504903 +4310 1027 4 0 24.056361 17.050512 18.710421 +4311 1028 6 0 -24.811053 1.584408 5.834113 +4312 1028 4 0 -25.507909 1.858017 6.420755 +4313 1028 4 0 -25.030959 2.043401 4.912778 +4314 1029 6 0 -17.538048 -16.019040 8.437894 +4315 1029 4 0 -16.656025 -15.917276 8.786670 +4316 1029 4 0 -18.001949 -16.630915 9.146335 +4317 1030 6 0 24.760362 7.007344 2.270076 +4318 1030 4 0 25.402754 6.314627 2.489308 +4319 1030 4 0 23.915754 6.586671 2.268737 +4320 1031 6 0 25.788659 -3.059441 10.761911 +4321 1031 4 0 26.310282 -3.490606 11.381049 +4322 1031 4 0 26.152501 -2.184136 10.493232 +4323 1032 6 0 0.555207 13.578019 -13.771204 +4324 1032 4 0 0.341766 12.780750 -14.192088 +4325 1032 4 0 0.413626 13.443525 -12.823611 +4326 1033 6 0 20.410457 17.119094 12.037026 +4327 1033 4 0 20.229518 17.254716 12.960534 +4328 1033 4 0 19.888401 16.300517 11.792550 +4329 1034 6 0 -23.997550 7.377972 16.665323 +4330 1034 4 0 -23.725736 7.038438 15.778438 +4331 1034 4 0 -23.233133 7.945952 17.026136 +4332 1035 6 0 10.209255 5.785175 12.171401 +4333 1035 4 0 10.101397 6.356166 11.459081 +4334 1035 4 0 9.657068 5.061974 12.024038 +4335 1036 6 0 18.434676 -10.560721 -17.755033 +4336 1036 4 0 18.443899 -11.522200 -17.622101 +4337 1036 4 0 18.319805 -10.178413 -16.882655 +4338 1037 6 0 -27.095192 -12.657493 -12.643385 +4339 1037 4 0 -26.627310 -12.318558 -13.484881 +4340 1037 4 0 -26.470420 -12.949131 -11.963689 +4341 1038 6 0 -16.616222 15.445597 -12.118963 +4342 1038 4 0 -16.900898 14.503610 -11.855586 +4343 1038 4 0 -15.694269 15.632029 -11.755889 +4344 1039 6 0 21.704052 -7.110846 5.569340 +4345 1039 4 0 21.462097 -8.042671 5.894386 +4346 1039 4 0 20.943089 -6.635884 5.906995 +4347 1040 6 0 18.206432 16.827370 1.010928 +4348 1040 4 0 17.640465 17.264033 0.353478 +4349 1040 4 0 17.852918 17.062780 1.898646 +4350 1041 6 0 -11.473367 18.497190 -2.566431 +4351 1041 4 0 -11.979906 19.196582 -2.198797 +4352 1041 4 0 -11.280546 18.932999 -3.450291 +4353 1042 6 0 17.797648 10.068787 -6.366632 +4354 1042 4 0 17.894506 9.407090 -5.699458 +4355 1042 4 0 18.545928 9.973231 -6.994936 +4356 1043 6 0 -18.401148 -11.350055 -12.827243 +4357 1043 4 0 -18.476782 -10.412318 -13.195678 +4358 1043 4 0 -17.491834 -11.585994 -12.934422 +4359 1044 6 0 -16.495719 -5.941792 10.422239 +4360 1044 4 0 -16.334766 -5.213442 11.122849 +4361 1044 4 0 -16.639135 -6.780551 10.923477 +4362 1045 6 0 -11.586396 18.803652 -7.549338 +4363 1045 4 0 -12.019098 18.189302 -8.166804 +4364 1045 4 0 -11.712347 18.317066 -6.668883 +4365 1046 6 0 11.058497 -1.697211 6.108850 +4366 1046 4 0 11.596453 -0.983751 6.451941 +4367 1046 4 0 10.144328 -1.357434 6.135852 +4368 1047 6 0 -6.655801 13.749288 -17.439254 +4369 1047 4 0 -7.132448 13.358752 -18.156046 +4370 1047 4 0 -7.118927 14.596314 -17.196637 +4371 1048 6 0 1.472049 -16.138831 -18.127087 +4372 1048 4 0 0.854396 -15.448228 -18.418147 +4373 1048 4 0 2.130556 -15.578106 -17.697816 +4374 1049 6 0 20.585602 0.045789 -20.805188 +4375 1049 4 0 19.811710 0.249922 -20.316920 +4376 1049 4 0 20.451948 -0.908979 -20.865716 +4377 1050 6 0 -17.322452 12.895993 -11.204513 +4378 1050 4 0 -17.802771 12.549260 -12.003007 +4379 1050 4 0 -17.950866 13.176295 -10.574188 +4380 1051 6 0 -5.523481 17.380120 9.246553 +4381 1051 4 0 -6.455503 17.665024 9.326329 +4382 1051 4 0 -5.168113 17.988295 8.544540 +4383 1052 6 0 -20.625677 5.350199 17.142096 +4384 1052 4 0 -20.365541 5.269750 16.185658 +4385 1052 4 0 -21.560214 5.201087 17.226176 +4386 1053 6 0 14.783181 -14.244465 0.085624 +4387 1053 4 0 14.103412 -14.020780 -0.585079 +4388 1053 4 0 15.175676 -13.378076 0.287496 +4389 1054 6 0 -6.126500 15.521051 20.750377 +4390 1054 4 0 -5.864785 16.375379 20.437098 +4391 1054 4 0 -5.831488 14.924080 20.076176 +4392 1055 6 0 23.807408 -1.524862 20.387679 +4393 1055 4 0 23.526614 -0.919002 21.138248 +4394 1055 4 0 24.692883 -1.828224 20.645004 +4395 1056 6 0 -19.809983 -10.410676 13.714221 +4396 1056 4 0 -20.768119 -10.598102 13.488906 +4397 1056 4 0 -19.553271 -11.125518 14.242975 +4398 1057 6 0 10.977545 9.011145 -2.389433 +4399 1057 4 0 10.555694 9.915559 -2.389522 +4400 1057 4 0 11.154202 8.870964 -1.470695 +4401 1058 6 0 -1.783860 4.881032 16.604931 +4402 1058 4 0 -1.311789 5.388703 17.223932 +4403 1058 4 0 -2.422445 4.514982 17.225489 +4404 1059 6 0 7.835617 -8.106110 -15.760424 +4405 1059 4 0 7.624633 -7.756681 -14.894547 +4406 1059 4 0 8.420342 -7.335138 -16.124751 +4407 1060 6 0 -23.662148 -13.962817 6.282978 +4408 1060 4 0 -23.067991 -14.398941 6.936570 +4409 1060 4 0 -23.877149 -14.577723 5.532763 +4410 1061 6 0 -23.624539 2.173832 -0.854956 +4411 1061 4 0 -23.179146 2.179020 0.040340 +4412 1061 4 0 -23.749597 1.237465 -1.001396 +4413 1062 6 0 -21.224847 4.257385 -6.009865 +4414 1062 4 0 -20.741474 3.800756 -5.299605 +4415 1062 4 0 -22.182298 4.137922 -5.723698 +4416 1063 6 0 -7.017487 16.063624 -12.051636 +4417 1063 4 0 -6.269158 16.416276 -11.536793 +4418 1063 4 0 -7.636713 15.594733 -11.454123 +4419 1064 6 0 -5.651528 10.093505 -13.321462 +4420 1064 4 0 -6.401351 10.663800 -13.086078 +4421 1064 4 0 -5.597617 10.115851 -14.301208 +4422 1065 6 0 21.418715 -14.140702 -12.149975 +4423 1065 4 0 21.861018 -14.674641 -11.447553 +4424 1065 4 0 21.182805 -13.281849 -11.830093 +4425 1066 6 0 11.675702 -2.428019 -16.058290 +4426 1066 4 0 12.296485 -3.131417 -15.821102 +4427 1066 4 0 10.819347 -2.825354 -16.198440 +4428 1067 6 0 22.979820 -2.598953 7.858168 +4429 1067 4 0 22.305897 -3.288078 7.958439 +4430 1067 4 0 22.577225 -1.844154 8.317572 +4431 1068 6 0 -12.448543 -5.982245 -10.570856 +4432 1068 4 0 -12.345287 -6.440367 -11.438582 +4433 1068 4 0 -12.479780 -5.112730 -10.871625 +4434 1069 6 0 -21.326982 14.741209 3.984994 +4435 1069 4 0 -22.133596 15.218464 4.095957 +4436 1069 4 0 -21.095649 14.791647 3.001164 +4437 1070 6 0 -18.292976 8.601702 17.515296 +4438 1070 4 0 -17.819784 7.959109 16.915944 +4439 1070 4 0 -18.716579 9.254092 16.954312 +4440 1071 6 0 20.829524 -9.495435 17.330944 +4441 1071 4 0 20.166412 -8.937403 16.904816 +4442 1071 4 0 20.227087 -10.108486 17.846508 +4443 1072 6 0 20.700328 -6.588173 14.108279 +4444 1072 4 0 21.318200 -6.371434 13.409947 +4445 1072 4 0 20.919049 -5.966297 14.775431 +4446 1073 6 0 20.232319 2.519356 -1.744863 +4447 1073 4 0 19.792632 2.343537 -0.866566 +4448 1073 4 0 20.751642 1.718603 -1.892919 +4449 1074 6 0 15.047686 14.467227 0.247890 +4450 1074 4 0 15.482736 13.695414 -0.222271 +4451 1074 4 0 15.218594 15.203623 -0.400616 +4452 1075 6 0 24.814901 -4.572712 18.521288 +4453 1075 4 0 24.436069 -3.989712 17.861088 +4454 1075 4 0 24.560432 -4.263207 19.423396 +4455 1076 6 0 3.169892 -14.115589 5.242292 +4456 1076 4 0 2.664005 -13.989979 6.094893 +4457 1076 4 0 4.025199 -14.428367 5.639157 +4458 1077 6 0 -17.864265 -2.850216 -5.852738 +4459 1077 4 0 -17.430066 -2.321482 -5.131734 +4460 1077 4 0 -17.446095 -3.672125 -5.727214 +4461 1078 6 0 -13.642312 16.367207 3.840240 +4462 1078 4 0 -13.546920 17.318166 3.892058 +4463 1078 4 0 -12.985388 16.154870 4.544614 +4464 1079 6 0 15.575472 3.168399 -6.551464 +4465 1079 4 0 15.114514 3.591709 -7.323565 +4466 1079 4 0 15.203187 3.608807 -5.831817 +4467 1080 6 0 -21.816911 -17.666243 7.967285 +4468 1080 4 0 -21.649191 -17.232658 7.144499 +4469 1080 4 0 -22.407552 -17.039323 8.334081 +4470 1081 6 0 -19.125021 -12.172620 15.597940 +4471 1081 4 0 -18.215275 -12.242849 15.770287 +4472 1081 4 0 -19.633754 -12.872939 15.973922 +4473 1082 6 0 17.584300 -5.074564 -0.037211 +4474 1082 4 0 18.183319 -5.137038 0.675699 +4475 1082 4 0 18.235909 -5.047683 -0.784982 +4476 1083 6 0 26.562235 4.146721 -10.779327 +4477 1083 4 0 27.258204 4.596271 -10.364313 +4478 1083 4 0 26.892796 3.237656 -11.037254 +4479 1084 6 0 -23.034850 1.331983 -7.473112 +4480 1084 4 0 -22.263084 1.153047 -6.915575 +4481 1084 4 0 -23.725786 1.086847 -6.826224 +4482 1085 6 0 24.491038 14.753421 2.384575 +4483 1085 4 0 24.275342 13.963741 2.927789 +4484 1085 4 0 25.462558 14.841355 2.559853 +4485 1086 6 0 25.756605 20.905461 -14.371089 +4486 1086 4 0 25.459034 20.605712 -13.483891 +4487 1086 4 0 25.637109 21.868510 -14.335232 +4488 1087 6 0 18.144532 -1.757335 -11.270502 +4489 1087 4 0 18.514080 -2.646244 -11.055555 +4490 1087 4 0 18.939318 -1.202686 -11.251734 +4491 1088 6 0 -8.201074 -18.018606 -17.312094 +4492 1088 4 0 -8.700168 -17.307968 -17.835946 +4493 1088 4 0 -7.577873 -18.381345 -17.962687 +4494 1089 6 0 -9.369914 -19.217851 -15.403305 +4495 1089 4 0 -8.952768 -18.975805 -16.243189 +4496 1089 4 0 -8.911643 -18.742350 -14.709664 +4497 1090 6 0 20.100577 4.488027 -15.212556 +4498 1090 4 0 20.248911 5.438169 -15.424742 +4499 1090 4 0 20.660237 3.933680 -15.689536 +4500 1091 6 0 -19.712024 -15.323556 12.551955 +4501 1091 4 0 -19.317175 -16.207750 12.463402 +4502 1091 4 0 -19.212616 -14.787825 13.210358 +4503 1092 6 0 3.258787 -7.943131 12.290678 +4504 1092 4 0 2.342628 -8.287555 12.320149 +4505 1092 4 0 3.267355 -6.993463 12.332634 +4506 1093 6 0 -18.302710 1.278985 -16.334436 +4507 1093 4 0 -17.378406 1.373256 -16.132103 +4508 1093 4 0 -18.777760 1.517880 -15.493665 +4509 1094 6 0 16.870546 4.656852 -17.868704 +4510 1094 4 0 15.857496 4.704340 -17.988259 +4511 1094 4 0 17.247038 4.338791 -18.723974 +4512 1095 6 0 -15.333473 15.071500 7.805725 +4513 1095 4 0 -15.704647 14.257623 8.137122 +4514 1095 4 0 -15.627172 15.251727 6.915271 +4515 1096 6 0 9.979483 20.165851 2.918770 +4516 1096 4 0 9.638769 20.645174 2.150266 +4517 1096 4 0 9.859690 19.210620 2.805973 +4518 1097 6 0 23.413497 4.631399 15.271695 +4519 1097 4 0 23.659592 4.570914 14.363590 +4520 1097 4 0 23.076746 5.481003 15.471203 +4521 1098 6 0 23.514270 -0.269090 17.919270 +4522 1098 4 0 23.883706 -0.646818 18.744448 +4523 1098 4 0 22.647737 0.129763 18.103196 +4524 1099 6 0 -24.064290 4.819702 1.332253 +4525 1099 4 0 -24.383325 4.040819 1.008702 +4526 1099 4 0 -23.189236 4.997095 0.898826 +4527 1100 6 0 -25.779315 -8.150537 18.610217 +4528 1100 4 0 -24.782772 -7.888401 18.544405 +4529 1100 4 0 -26.257671 -7.381934 18.370006 +4530 1101 6 0 23.115913 16.716123 3.668102 +4531 1101 4 0 23.749362 16.385349 2.997452 +4532 1101 4 0 23.088241 17.666029 3.599261 +4533 1102 6 0 -20.088868 -15.143633 -10.159937 +4534 1102 4 0 -19.953025 -14.270168 -10.582681 +4535 1102 4 0 -19.990998 -15.687042 -10.954781 +4536 1103 6 0 7.102126 -1.136927 20.971306 +4537 1103 4 0 6.576190 -1.521838 20.280208 +4538 1103 4 0 7.955207 -1.040834 20.509983 +4539 1104 6 0 -2.534299 9.690544 11.933304 +4540 1104 4 0 -2.860248 8.888179 11.453477 +4541 1104 4 0 -1.828854 10.072496 11.393589 +4542 1105 6 0 12.023524 -9.150206 -14.165841 +4543 1105 4 0 11.362618 -9.759930 -14.520833 +4544 1105 4 0 12.740525 -9.263946 -14.788240 +4545 1106 6 0 15.791803 18.545995 0.850378 +4546 1106 4 0 16.437977 18.981342 1.416680 +4547 1106 4 0 14.975349 18.624193 1.311898 +4548 1107 6 0 -23.993331 13.937802 7.429388 +4549 1107 4 0 -23.946766 13.591295 6.487146 +4550 1107 4 0 -23.318125 14.639075 7.439315 +4551 1108 6 0 23.938328 -2.346007 3.554880 +4552 1108 4 0 24.343685 -3.093714 4.072487 +4553 1108 4 0 24.649326 -2.174810 2.889988 +4554 1109 6 0 -1.744771 13.957566 2.002292 +4555 1109 4 0 -0.940707 14.398422 2.247093 +4556 1109 4 0 -2.025476 14.420450 1.204293 +4557 1110 6 0 -25.534328 -15.482539 7.809635 +4558 1110 4 0 -25.054678 -15.173162 7.005447 +4559 1110 4 0 -26.465036 -15.629268 7.587481 +4560 1111 6 0 24.624742 -18.307755 -10.821110 +4561 1111 4 0 23.724217 -18.723401 -10.975653 +4562 1111 4 0 24.780187 -17.602754 -11.546790 +4563 1112 6 0 -21.325143 19.316329 -1.400937 +4564 1112 4 0 -21.154588 18.656956 -0.705637 +4565 1112 4 0 -20.679486 19.156150 -2.095481 +4566 1113 6 0 0.559384 -5.922570 14.213390 +4567 1113 4 0 1.239405 -5.963730 14.899585 +4568 1113 4 0 0.030681 -5.131536 14.297850 +4569 1114 6 0 7.056613 12.758986 15.777863 +4570 1114 4 0 6.345829 12.596606 16.456405 +4571 1114 4 0 6.917568 12.084839 15.095389 +4572 1115 6 0 7.882824 3.878180 -19.492657 +4573 1115 4 0 7.490185 4.569137 -19.983338 +4574 1115 4 0 7.617907 3.037912 -19.945297 +4575 1116 6 0 -4.242915 -9.821169 16.240099 +4576 1116 4 0 -5.114830 -10.078772 16.528494 +4577 1116 4 0 -4.353835 -8.852979 15.979121 +4578 1117 6 0 15.302976 18.208896 -11.851032 +4579 1117 4 0 14.901111 18.506138 -12.642478 +4580 1117 4 0 14.917266 17.320837 -11.712610 +4581 1118 6 0 -18.266869 -16.450266 -8.528802 +4582 1118 4 0 -19.072723 -16.071961 -9.086324 +4583 1118 4 0 -18.243043 -17.366820 -8.807270 +4584 1119 6 0 16.535819 -20.059315 20.261479 +4585 1119 4 0 16.531825 -20.982895 19.988148 +4586 1119 4 0 16.217098 -19.563433 19.483491 +4587 1120 6 0 -10.711611 3.116140 -11.835025 +4588 1120 4 0 -10.699224 2.230856 -12.204415 +4589 1120 4 0 -10.469479 3.689824 -12.532473 +4590 1121 6 0 -3.907796 14.129489 -14.135830 +4591 1121 4 0 -3.774958 15.065764 -14.110303 +4592 1121 4 0 -4.871885 13.969469 -14.280187 +4593 1122 6 0 -0.848559 15.883551 -14.784892 +4594 1122 4 0 -0.414200 14.990499 -14.630689 +4595 1122 4 0 -1.164070 15.745918 -15.703167 +4596 1123 6 0 26.710694 15.162885 -7.381020 +4597 1123 4 0 26.708875 16.144027 -7.444500 +4598 1123 4 0 27.516272 14.997257 -7.900997 +4599 1124 6 0 -20.320110 2.222669 -14.437513 +4600 1124 4 0 -20.674693 1.937159 -13.587288 +4601 1124 4 0 -21.090888 2.252982 -14.954492 +4602 1125 6 0 -18.681714 17.640935 -1.514728 +4603 1125 4 0 -19.273979 17.179134 -2.084688 +4604 1125 4 0 -18.333083 16.926527 -0.959606 +4605 1126 6 0 26.297214 0.194896 -8.814341 +4606 1126 4 0 26.092612 0.771392 -8.062520 +4607 1126 4 0 25.469129 -0.223458 -9.080468 +4608 1127 6 0 5.191134 -6.332696 -10.274288 +4609 1127 4 0 6.147598 -6.194127 -10.166488 +4610 1127 4 0 4.968608 -5.815003 -11.012193 +4611 1128 6 0 20.219068 -19.874563 -6.779564 +4612 1128 4 0 19.984433 -20.709740 -7.181101 +4613 1128 4 0 20.478152 -20.150413 -5.862690 +4614 1129 6 0 15.925069 -5.315100 -4.962971 +4615 1129 4 0 16.483651 -4.538813 -4.855095 +4616 1129 4 0 16.031011 -5.844220 -4.094051 +4617 1130 6 0 -24.041642 -19.508457 3.561309 +4618 1130 4 0 -23.889244 -19.214184 4.445568 +4619 1130 4 0 -23.734917 -20.488280 3.584072 +4620 1131 6 0 -7.947126 8.409362 14.208637 +4621 1131 4 0 -8.729737 8.295090 13.605991 +4622 1131 4 0 -7.220157 7.896970 13.768244 +4623 1132 6 0 -20.888915 18.615896 3.147997 +4624 1132 4 0 -20.353651 18.339741 3.899224 +4625 1132 4 0 -20.608848 18.126465 2.400982 +4626 1133 6 0 26.799597 -16.513942 12.340813 +4627 1133 4 0 27.311676 -15.749176 12.455669 +4628 1133 4 0 26.641412 -16.884054 13.252799 +4629 1134 6 0 22.610810 -16.125525 -11.025534 +4630 1134 4 0 23.428805 -16.214604 -10.496780 +4631 1134 4 0 22.231404 -17.004775 -11.137826 +4632 1135 6 0 23.631086 9.762764 -6.151528 +4633 1135 4 0 22.831437 10.283165 -6.251895 +4634 1135 4 0 23.313903 8.866850 -6.410178 +4635 1136 6 0 10.407629 -5.135788 9.642425 +4636 1136 4 0 9.500671 -5.522467 9.593528 +4637 1136 4 0 10.722620 -5.079856 8.742604 +4638 1137 6 0 4.000382 -9.483456 -16.043131 +4639 1137 4 0 4.388443 -8.972484 -16.767773 +4640 1137 4 0 3.270597 -9.958423 -16.410357 +4641 1138 6 0 -25.904986 -15.880364 18.652683 +4642 1138 4 0 -26.778482 -15.886913 19.026359 +4643 1138 4 0 -25.526797 -16.780938 18.932335 +4644 1139 6 0 15.308933 1.325497 -13.930838 +4645 1139 4 0 15.049598 0.974163 -14.793125 +4646 1139 4 0 14.735466 2.123881 -13.829588 +4647 1140 6 0 -6.379415 2.888159 -18.944523 +4648 1140 4 0 -6.573457 2.028181 -19.291846 +4649 1140 4 0 -5.489918 2.985716 -19.266815 +4650 1141 6 0 -1.982477 0.360990 19.729630 +4651 1141 4 0 -2.393479 -0.007753 20.516214 +4652 1141 4 0 -2.616886 0.223553 19.013623 +4653 1142 6 0 1.410741 17.503605 17.946189 +4654 1142 4 0 1.299933 17.358511 17.001928 +4655 1142 4 0 1.382712 16.600387 18.282286 +4656 1143 6 0 -17.081613 19.032309 -4.304375 +4657 1143 4 0 -18.004189 18.728506 -4.171643 +4658 1143 4 0 -16.569290 18.434220 -3.790534 +4659 1144 6 0 26.981274 -11.552908 -3.820441 +4660 1144 4 0 26.121174 -11.624996 -4.253473 +4661 1144 4 0 27.276376 -10.703146 -4.209015 +4662 1145 6 0 20.095481 18.572235 3.036961 +4663 1145 4 0 20.026299 17.806007 3.594224 +4664 1145 4 0 20.832186 19.036343 3.467658 +4665 1146 6 0 -19.905861 6.946943 4.083849 +4666 1146 4 0 -19.307403 7.160688 3.357801 +4667 1146 4 0 -20.728729 7.427643 3.991449 +4668 1147 6 0 22.217595 -4.822160 -10.650121 +4669 1147 4 0 22.159340 -5.054178 -11.530210 +4670 1147 4 0 21.255204 -4.714847 -10.351112 +4671 1148 6 0 12.390352 -19.538948 -0.083493 +4672 1148 4 0 13.062326 -18.900361 -0.469572 +4673 1148 4 0 11.739170 -19.679826 -0.768861 +4674 1149 6 0 -11.756735 -11.595474 -18.753407 +4675 1149 4 0 -10.845705 -11.914606 -18.999006 +4676 1149 4 0 -11.631200 -10.619419 -18.528946 +4677 1150 6 0 16.531650 8.079043 16.659190 +4678 1150 4 0 16.426030 8.463579 15.788072 +4679 1150 4 0 17.442132 8.278108 16.859520 +4680 1151 6 0 10.052731 8.649788 -10.126307 +4681 1151 4 0 10.131192 7.907466 -9.580859 +4682 1151 4 0 10.118299 9.470033 -9.652222 +4683 1152 6 0 10.138877 6.520965 -16.282122 +4684 1152 4 0 9.429867 6.198945 -15.746097 +4685 1152 4 0 9.762597 7.172991 -16.879414 +4686 1153 6 0 -5.128627 7.237138 -16.384778 +4687 1153 4 0 -4.943315 6.311211 -16.467826 +4688 1153 4 0 -4.299328 7.630954 -16.159960 +4689 1154 6 0 18.467732 -4.333427 -7.973507 +4690 1154 4 0 17.685481 -3.749427 -7.814406 +4691 1154 4 0 18.051764 -5.199527 -7.872728 +4692 1155 6 0 -22.790877 -7.110126 -2.658913 +4693 1155 4 0 -22.592444 -7.612682 -1.822969 +4694 1155 4 0 -23.671839 -6.831554 -2.552705 +4695 1156 6 0 -5.452870 -18.001674 4.454273 +4696 1156 4 0 -5.227357 -18.684872 5.061214 +4697 1156 4 0 -6.200455 -17.594596 4.818204 +4698 1157 6 0 6.056152 -17.434479 -7.972778 +4699 1157 4 0 6.787809 -18.060671 -8.028928 +4700 1157 4 0 5.440331 -17.702859 -7.267591 +4701 1158 6 0 1.714168 -18.930287 -17.718130 +4702 1158 4 0 1.740272 -18.003727 -18.035560 +4703 1158 4 0 0.785802 -19.119877 -17.580120 +4704 1159 6 0 12.454449 16.569541 -9.572034 +4705 1159 4 0 13.143421 15.995002 -9.358789 +4706 1159 4 0 11.970081 16.409711 -8.733167 +4707 1160 6 0 21.377566 -4.531623 -13.959167 +4708 1160 4 0 21.220313 -4.586863 -14.883806 +4709 1160 4 0 20.718007 -3.864167 -13.706228 +4710 1161 6 0 27.229945 -1.071212 -13.106863 +4711 1161 4 0 26.536738 -0.401088 -12.953451 +4712 1161 4 0 27.406489 -1.591477 -12.306455 +4713 1162 6 0 0.993205 -20.183906 13.537173 +4714 1162 4 0 1.864290 -20.100713 13.823720 +4715 1162 4 0 0.417346 -20.489716 14.247240 +4716 1163 6 0 22.306745 2.581458 8.736617 +4717 1163 4 0 22.972169 3.057047 8.241655 +4718 1163 4 0 21.515448 2.587605 8.237638 +4719 1164 6 0 -24.994740 17.845616 8.243126 +4720 1164 4 0 -25.935974 17.671320 8.306538 +4721 1164 4 0 -24.615426 17.427508 9.019818 +4722 1165 6 0 3.628195 -4.198159 -16.200147 +4723 1165 4 0 4.404223 -4.757640 -16.114355 +4724 1165 4 0 2.941004 -4.862278 -16.461468 +4725 1166 6 0 26.808990 -14.261974 -5.551088 +4726 1166 4 0 26.801404 -13.726938 -6.334245 +4727 1166 4 0 25.872464 -14.345791 -5.184066 +4728 1167 6 0 13.355891 -16.600141 -3.794039 +4729 1167 4 0 13.295908 -17.531097 -3.472837 +4730 1167 4 0 14.114590 -16.215977 -3.304966 +4731 1168 6 0 -5.285172 -14.650134 6.726219 +4732 1168 4 0 -5.321392 -15.573092 6.451324 +4733 1168 4 0 -5.705533 -14.040342 6.049451 +4734 1169 6 0 -15.245133 11.577568 10.198692 +4735 1169 4 0 -14.684069 10.842805 9.868029 +4736 1169 4 0 -15.899308 11.783343 9.507232 +4737 1170 6 0 17.485666 -16.919340 -6.354127 +4738 1170 4 0 17.235852 -17.135664 -7.261939 +4739 1170 4 0 18.432637 -16.981881 -6.360484 +4740 1171 6 0 -9.901382 -6.924152 -10.070687 +4741 1171 4 0 -10.735776 -6.481799 -9.885298 +4742 1171 4 0 -10.186933 -7.424453 -10.836686 +4743 1172 6 0 -24.779066 9.890774 -10.589824 +4744 1172 4 0 -24.555747 10.752218 -10.986744 +4745 1172 4 0 -24.892417 10.088688 -9.640328 +4746 1173 6 0 -22.615173 9.224641 6.611089 +4747 1173 4 0 -22.778201 8.680839 5.764537 +4748 1173 4 0 -23.446696 9.423303 6.964274 +4749 1174 6 0 9.268447 -16.931793 -5.987149 +4750 1174 4 0 8.956403 -16.451784 -6.788388 +4751 1174 4 0 9.877183 -16.351625 -5.503938 +4752 1175 6 0 -14.656535 1.482956 18.890158 +4753 1175 4 0 -15.369331 1.942366 19.276786 +4754 1175 4 0 -14.153965 0.952532 19.494908 +4755 1176 6 0 5.277331 10.616617 -11.480664 +4756 1176 4 0 5.005306 11.447583 -11.898782 +4757 1176 4 0 5.358629 10.918462 -10.514309 +4758 1177 6 0 25.665486 11.699398 -16.256540 +4759 1177 4 0 25.839240 12.448046 -15.719245 +4760 1177 4 0 25.814575 10.942656 -15.634104 +4761 1178 6 0 21.920761 20.073624 -12.126972 +4762 1178 4 0 22.552772 19.967397 -11.382127 +4763 1178 4 0 21.479644 19.202351 -12.146674 +4764 1179 6 0 10.003073 19.989386 -7.403776 +4765 1179 4 0 9.439166 20.478736 -6.817011 +4766 1179 4 0 9.975278 19.064238 -7.087034 +4767 1180 6 0 24.639512 10.361086 12.201260 +4768 1180 4 0 24.706246 9.532944 12.698966 +4769 1180 4 0 25.008910 11.010832 12.873283 +4770 1181 6 0 -4.551351 -13.614062 11.550986 +4771 1181 4 0 -3.695594 -13.200426 11.181108 +4772 1181 4 0 -4.841622 -13.040560 12.238016 +4773 1182 6 0 13.925499 -14.277948 -16.852509 +4774 1182 4 0 13.468499 -13.949023 -16.059490 +4775 1182 4 0 13.404967 -13.901558 -17.624653 +4776 1183 6 0 -8.822453 18.672284 -1.497284 +4777 1183 4 0 -9.773739 18.628726 -1.762866 +4778 1183 4 0 -8.737384 19.554941 -1.117958 +4779 1184 6 0 -22.502543 14.174443 -14.775760 +4780 1184 4 0 -23.095969 13.602099 -14.242424 +4781 1184 4 0 -22.857075 15.080918 -14.689705 +4782 1185 6 0 14.064111 -5.559010 13.387762 +4783 1185 4 0 14.064485 -4.565565 13.355502 +4784 1185 4 0 13.283489 -5.675258 12.845674 +4785 1186 6 0 1.894767 -5.320136 -19.924307 +4786 1186 4 0 1.751326 -5.338831 -18.971201 +4787 1186 4 0 2.815685 -5.078504 -20.067932 +4788 1187 6 0 25.294324 -10.049317 -2.168254 +4789 1187 4 0 24.998964 -9.181655 -2.438448 +4790 1187 4 0 25.460965 -9.966915 -1.197557 +4791 1188 6 0 6.479700 -19.891353 1.298943 +4792 1188 4 0 5.533528 -20.103717 1.361966 +4793 1188 4 0 6.573201 -19.075339 0.809570 +4794 1189 6 0 -27.363431 -16.882485 4.699786 +4795 1189 4 0 -26.488335 -16.423824 4.667383 +4796 1189 4 0 -27.778495 -16.519493 5.529189 +4797 1190 6 0 21.647371 -10.967083 -0.688726 +4798 1190 4 0 21.307654 -11.566578 -0.059145 +4799 1190 4 0 20.903506 -10.948374 -1.343290 +4800 1191 6 0 -22.639740 18.869062 12.772784 +4801 1191 4 0 -23.598249 18.977251 12.816087 +4802 1191 4 0 -22.528147 18.565590 11.856412 +4803 1192 6 0 -19.354849 19.459324 -20.763860 +4804 1192 4 0 -19.638921 18.619981 -20.405119 +4805 1192 4 0 -19.999366 20.121418 -20.384538 +4806 1193 6 0 -27.292577 17.947849 -7.899480 +4807 1193 4 0 -26.865640 18.369463 -8.665053 +4808 1193 4 0 -26.976583 18.519563 -7.163255 +4809 1194 6 0 -20.817821 -2.868450 14.802525 +4810 1194 4 0 -21.140828 -3.572172 14.242551 +4811 1194 4 0 -21.382527 -2.899729 15.647552 +4812 1195 6 0 -26.483700 3.477220 -8.027358 +4813 1195 4 0 -27.118971 4.203207 -8.001463 +4814 1195 4 0 -25.572543 3.766211 -8.004075 +4815 1196 6 0 -20.066885 -9.761422 6.553470 +4816 1196 4 0 -20.997945 -9.935159 6.946701 +4817 1196 4 0 -19.442249 -9.796491 7.281455 +4818 1197 6 0 -23.097741 6.873436 -18.392975 +4819 1197 4 0 -22.589483 6.725087 -19.200274 +4820 1197 4 0 -22.785797 7.752769 -18.098029 +4821 1198 6 0 18.849536 1.746914 0.846251 +4822 1198 4 0 18.128002 2.129064 0.287715 +4823 1198 4 0 19.181226 2.420341 1.435040 +4824 1199 6 0 27.002887 18.923510 11.873786 +4825 1199 4 0 27.227664 19.764419 11.414163 +4826 1199 4 0 26.105946 19.033421 11.984937 +4827 1200 6 0 -11.158512 11.141322 18.442481 +4828 1200 4 0 -11.408050 10.995491 17.540347 +4829 1200 4 0 -10.502213 10.475024 18.734764 +4830 1201 6 0 -21.495790 -1.351514 -4.237645 +4831 1201 4 0 -21.044359 -1.664515 -3.433502 +4832 1201 4 0 -22.384314 -1.671646 -4.060127 +4833 1202 6 0 15.621755 -15.205139 -2.495677 +4834 1202 4 0 15.424484 -14.934581 -1.611471 +4835 1202 4 0 16.121625 -14.529114 -2.853796 +4836 1203 6 0 4.381992 13.875981 -1.032186 +4837 1203 4 0 5.333475 13.689707 -0.896179 +4838 1203 4 0 4.022732 13.223499 -1.665135 +4839 1204 6 0 20.177887 10.395959 -3.696541 +4840 1204 4 0 20.356404 10.914845 -4.496586 +4841 1204 4 0 20.991017 10.244340 -3.211612 +4842 1205 6 0 15.157815 19.249081 -18.039544 +4843 1205 4 0 15.352336 20.161425 -17.776001 +4844 1205 4 0 15.059841 19.346261 -19.002141 +4845 1206 6 0 -7.108984 -13.295157 15.804846 +4846 1206 4 0 -6.929809 -14.169985 15.496547 +4847 1206 4 0 -6.361874 -13.100921 16.402035 +4848 1207 6 0 -25.065030 -11.005040 18.970744 +4849 1207 4 0 -25.902113 -11.429253 18.763963 +4850 1207 4 0 -25.182957 -10.072508 18.787257 +4851 1208 6 0 11.932413 -6.103636 -13.397989 +4852 1208 4 0 12.570617 -5.775336 -12.776618 +4853 1208 4 0 12.223586 -6.926860 -13.765008 +4854 1209 6 0 -25.022964 -4.047632 -16.421532 +4855 1209 4 0 -24.729550 -4.908790 -16.087160 +4856 1209 4 0 -24.546933 -3.445338 -15.856315 +4857 1210 6 0 -2.351505 -13.799895 -9.640381 +4858 1210 4 0 -2.806266 -13.103621 -10.108151 +4859 1210 4 0 -1.432803 -13.498454 -9.473869 +4860 1211 6 0 -17.970640 -1.824370 11.981061 +4861 1211 4 0 -18.720197 -1.276483 12.154733 +4862 1211 4 0 -17.669382 -2.084512 12.859437 +4863 1212 6 0 16.682335 16.786230 -5.408443 +4864 1212 4 0 15.963934 17.446355 -5.166695 +4865 1212 4 0 16.709036 16.877417 -6.391919 +4866 1213 6 0 -26.984415 4.176614 -3.075863 +4867 1213 4 0 -26.123649 4.345106 -2.684692 +4868 1213 4 0 -26.853761 3.725314 -3.913099 +4869 1214 6 0 -26.077892 0.261300 17.719641 +4870 1214 4 0 -26.784019 0.913023 17.543217 +4871 1214 4 0 -26.472468 -0.574255 17.882963 +4872 1215 6 0 22.927522 20.111945 -15.638008 +4873 1215 4 0 23.596986 20.008343 -14.934189 +4874 1215 4 0 22.343012 20.821690 -15.365852 +4875 1216 6 0 -5.579568 -12.021256 13.421129 +4876 1216 4 0 -5.890589 -11.086014 13.250578 +4877 1216 4 0 -6.303487 -12.389144 13.952477 +4878 1217 6 0 2.458268 -17.079274 7.291369 +4879 1217 4 0 2.320253 -17.365496 8.234460 +4880 1217 4 0 1.770368 -16.394030 7.185697 +4881 1218 6 0 -24.595173 -15.448874 14.340370 +4882 1218 4 0 -23.877774 -15.587584 14.998240 +4883 1218 4 0 -25.176320 -14.635721 14.530870 +4884 1219 6 0 27.032054 -9.403183 3.148273 +4885 1219 4 0 26.403900 -8.794366 3.626157 +4886 1219 4 0 27.383095 -9.993711 3.825592 +4887 1220 6 0 -20.726606 14.795856 1.273133 +4888 1220 4 0 -19.806504 14.435167 1.199972 +4889 1220 4 0 -21.276966 14.325769 0.588346 +4890 1221 6 0 -24.967956 8.541628 1.328681 +4891 1221 4 0 -24.984827 9.452469 1.040896 +4892 1221 4 0 -25.740396 8.434977 1.929151 +4893 1222 6 0 -12.425328 11.518457 -14.199688 +4894 1222 4 0 -12.773966 12.392793 -14.015441 +4895 1222 4 0 -13.118630 10.965584 -13.849575 +4896 1223 6 0 -2.529035 -2.360811 17.836544 +4897 1223 4 0 -3.234696 -2.119216 18.386147 +4898 1223 4 0 -1.867440 -1.729883 18.015495 +4899 1224 6 0 -21.776402 4.919177 -10.291667 +4900 1224 4 0 -22.083924 5.863215 -10.349382 +4901 1224 4 0 -22.101633 4.482076 -11.074994 +4902 1225 6 0 6.293596 15.999990 18.747555 +4903 1225 4 0 5.792274 16.524552 19.421554 +4904 1225 4 0 5.641363 15.346197 18.513974 +4905 1226 6 0 8.520334 14.536496 -17.222476 +4906 1226 4 0 9.367910 14.362425 -16.812169 +4907 1226 4 0 8.183656 13.684606 -17.523424 +4908 1227 6 0 22.691056 10.129741 -9.774947 +4909 1227 4 0 22.388373 10.989892 -9.545078 +4910 1227 4 0 23.520258 10.122274 -10.228776 +4911 1228 6 0 11.292032 2.127043 14.679028 +4912 1228 4 0 10.300438 2.012949 14.574584 +4913 1228 4 0 11.707898 2.382716 13.839204 +4914 1229 6 0 -10.080449 15.590962 -5.638342 +4915 1229 4 0 -9.913581 15.482801 -6.607010 +4916 1229 4 0 -11.000029 15.446049 -5.572110 +4917 1230 6 0 9.724654 19.017882 -10.687275 +4918 1230 4 0 10.589720 19.426462 -10.594122 +4919 1230 4 0 9.112520 19.575919 -10.256988 +4920 1231 6 0 -3.018641 7.588470 16.688095 +4921 1231 4 0 -2.330160 6.909662 16.567035 +4922 1231 4 0 -3.336233 7.572799 15.739189 +4923 1232 6 0 -23.558310 -7.134740 -5.487980 +4924 1232 4 0 -23.265138 -7.142827 -4.583180 +4925 1232 4 0 -23.745933 -6.250685 -5.834602 +4926 1233 6 0 4.226629 15.093702 15.365734 +4927 1233 4 0 4.100578 14.882406 16.320809 +4928 1233 4 0 5.174530 15.177349 15.271261 +4929 1234 6 0 -7.236890 20.676688 -13.887599 +4930 1234 4 0 -7.297460 19.771023 -14.250227 +4931 1234 4 0 -6.598431 21.116314 -14.486914 +4932 1235 6 0 15.815010 1.151652 -17.502222 +4933 1235 4 0 15.282468 0.557615 -16.965425 +4934 1235 4 0 15.054480 1.630363 -17.957554 +4935 1236 6 0 -20.408893 -2.203285 -1.832435 +4936 1236 4 0 -20.785863 -1.600728 -1.206934 +4937 1236 4 0 -20.672903 -3.085785 -1.719471 +4938 1237 6 0 20.195914 -9.732203 -7.503586 +4939 1237 4 0 19.775594 -9.020266 -6.898678 +4940 1237 4 0 21.112065 -9.804356 -7.217365 +4941 1238 6 0 19.296629 -3.381575 11.843745 +4942 1238 4 0 19.274699 -4.314587 11.989050 +4943 1238 4 0 20.065392 -3.074363 12.391528 +4944 1239 6 0 6.531812 13.501627 -15.078637 +4945 1239 4 0 5.967341 14.060209 -15.705952 +4946 1239 4 0 6.508026 12.632112 -15.439267 +4947 1240 6 0 23.589867 -10.343367 -8.571682 +4948 1240 4 0 23.047931 -10.296334 -7.779151 +4949 1240 4 0 23.642788 -11.281031 -8.849406 +4950 1241 6 0 -13.933420 -9.985099 16.210161 +4951 1241 4 0 -13.061691 -9.875550 16.658981 +4952 1241 4 0 -13.656103 -10.632088 15.489463 +4953 1242 6 0 -23.237683 18.866731 19.359260 +4954 1242 4 0 -22.914140 19.726873 19.738290 +4955 1242 4 0 -23.718173 18.429834 20.073905 +4956 1243 6 0 10.494095 4.110524 19.341374 +4957 1243 4 0 9.723154 4.572616 18.942773 +4958 1243 4 0 11.209458 4.339646 18.681127 +4959 1244 6 0 1.369329 -9.441779 19.284078 +4960 1244 4 0 2.015289 -10.186860 19.212218 +4961 1244 4 0 1.015324 -9.189016 18.436693 +4962 1245 6 0 -12.121346 16.858305 -16.912154 +4963 1245 4 0 -12.482071 17.717178 -16.927558 +4964 1245 4 0 -11.557811 16.791147 -17.773819 +4965 1246 6 0 -9.672999 19.181029 4.107845 +4966 1246 4 0 -8.970953 19.839775 3.892751 +4967 1246 4 0 -10.347573 19.719934 4.574402 +4968 1247 6 0 -25.848254 19.893856 -6.158583 +4969 1247 4 0 -26.297371 20.306721 -5.458518 +4970 1247 4 0 -25.747309 20.595741 -6.795744 +4971 1248 6 0 -23.033567 -20.060181 19.659192 +4972 1248 4 0 -22.235177 -19.955724 19.067747 +4973 1248 4 0 -23.368334 -19.148619 19.847979 +4974 1249 6 0 -15.791938 8.271699 18.828418 +4975 1249 4 0 -16.027582 7.356294 18.646313 +4976 1249 4 0 -16.655172 8.767091 18.686291 +4977 1250 6 0 -21.708167 13.277512 -0.641646 +4978 1250 4 0 -22.597047 13.562637 -0.909355 +4979 1250 4 0 -21.809236 12.333829 -0.325507 +4980 1251 6 0 5.941295 -12.360207 -6.112984 +4981 1251 4 0 6.359630 -11.626042 -5.736075 +4982 1251 4 0 6.495648 -12.726477 -6.802834 +4983 1252 6 0 13.032092 -7.701355 -9.994956 +4984 1252 4 0 13.027162 -8.501577 -10.533994 +4985 1252 4 0 12.548921 -8.005933 -9.172971 +4986 1253 6 0 -21.030949 -20.119698 18.010996 +4987 1253 4 0 -20.244199 -20.716690 18.012037 +4988 1253 4 0 -20.696565 -19.252737 17.848450 +4989 1254 6 0 -19.015223 -0.571456 18.155941 +4990 1254 4 0 -19.180719 -0.389583 17.176932 +4991 1254 4 0 -18.385462 0.098617 18.394716 +4992 1255 6 0 -20.138485 -4.252628 -11.316573 +4993 1255 4 0 -19.840849 -5.049159 -11.793063 +4994 1255 4 0 -20.052902 -4.580000 -10.382886 +4995 1256 6 0 26.001968 -7.495414 4.672795 +4996 1256 4 0 25.441451 -7.324776 5.428706 +4997 1256 4 0 26.791498 -7.049997 4.959197 +4998 1257 6 0 19.055181 -8.349517 1.323580 +4999 1257 4 0 19.813936 -8.781204 1.703347 +5000 1257 4 0 19.440205 -7.777422 0.589952 +5001 1258 6 0 25.264798 8.233933 8.591555 +5002 1258 4 0 25.487528 8.137778 9.540405 +5003 1258 4 0 25.431397 9.162412 8.389274 +5004 1259 6 0 12.847916 19.693484 13.048286 +5005 1259 4 0 11.960267 19.995654 12.950099 +5006 1259 4 0 13.352276 20.516003 12.895948 +5007 1260 6 0 -1.639765 11.429914 5.808063 +5008 1260 4 0 -1.143950 12.047063 6.360614 +5009 1260 4 0 -2.350791 11.948090 5.492463 +5010 1261 6 0 9.848758 16.041115 -10.707370 +5011 1261 4 0 9.065082 15.706216 -11.123228 +5012 1261 4 0 9.845269 17.025290 -10.747608 +5013 1262 6 0 25.426954 20.293141 3.300623 +5014 1262 4 0 25.545358 20.769417 4.152492 +5015 1262 4 0 25.632270 21.033287 2.715396 +5016 1263 6 0 20.761109 8.207487 15.638898 +5017 1263 4 0 20.452100 8.556874 16.455577 +5018 1263 4 0 20.418491 7.276974 15.507884 +5019 1264 6 0 -17.340920 8.603213 9.973826 +5020 1264 4 0 -17.013776 7.715227 10.202262 +5021 1264 4 0 -17.708959 8.550775 9.106960 +5022 1265 6 0 -4.331343 4.519352 -17.647753 +5023 1265 4 0 -5.066787 3.870671 -17.637369 +5024 1265 4 0 -3.551869 3.998790 -17.434586 +5025 1266 6 0 20.173773 -17.092486 -7.001341 +5026 1266 4 0 19.888855 -16.443588 -7.714490 +5027 1266 4 0 20.413820 -17.900629 -7.443434 +5028 1267 6 0 -24.408814 -19.385733 11.225815 +5029 1267 4 0 -23.821161 -19.917061 10.749392 +5030 1267 4 0 -23.910074 -18.660169 11.617528 +5031 1268 6 0 17.324633 -1.128975 8.030022 +5032 1268 4 0 17.360905 -1.837044 8.692495 +5033 1268 4 0 18.151746 -0.980682 7.588726 +5034 1269 6 0 23.955106 -0.867756 -15.846487 +5035 1269 4 0 24.366679 -1.312193 -16.592677 +5036 1269 4 0 23.040207 -0.721605 -15.963924 +5037 1270 6 0 9.794322 -16.325238 -14.689703 +5038 1270 4 0 10.077445 -16.942203 -15.418778 +5039 1270 4 0 10.274190 -16.591924 -13.896103 +5040 1271 6 0 -19.734101 -12.095151 -17.153284 +5041 1271 4 0 -20.605684 -12.154989 -17.550952 +5042 1271 4 0 -19.490756 -11.177750 -17.393726 +5043 1272 6 0 2.145542 4.244476 10.559284 +5044 1272 4 0 1.712137 4.346774 11.448612 +5045 1272 4 0 1.552348 4.733416 9.969137 +5046 1273 6 0 -11.816250 3.934419 -18.405990 +5047 1273 4 0 -11.103191 4.038219 -19.027130 +5048 1273 4 0 -12.427642 3.303177 -18.846649 +5049 1274 6 0 18.893576 -19.279190 2.434753 +5050 1274 4 0 19.835933 -19.611541 2.415682 +5051 1274 4 0 18.743093 -19.115267 3.373179 +5052 1275 6 0 20.503855 18.939356 -0.359795 +5053 1275 4 0 20.047818 18.683781 0.506021 +5054 1275 4 0 19.907310 19.650581 -0.623461 +5055 1276 6 0 26.407017 7.546865 -12.797932 +5056 1276 4 0 25.672384 7.104790 -13.280274 +5057 1276 4 0 27.091777 7.777455 -13.451817 +5058 1277 6 0 25.647383 -6.341604 -8.154924 +5059 1277 4 0 26.357304 -5.715813 -8.365206 +5060 1277 4 0 25.997425 -7.137628 -8.663351 +5061 1278 6 0 24.828979 0.493040 8.418984 +5062 1278 4 0 25.575762 0.370102 9.128898 +5063 1278 4 0 24.779810 -0.342584 8.014099 +5064 1279 6 0 17.019067 17.317670 3.445072 +5065 1279 4 0 16.246945 17.951681 3.647617 +5066 1279 4 0 17.118513 16.924515 4.354268 +5067 1280 6 0 -14.811273 -9.813473 19.349487 +5068 1280 4 0 -15.258466 -10.583929 19.669257 +5069 1280 4 0 -14.033228 -10.041012 18.847205 +5070 1281 6 0 23.382015 -15.215511 6.306360 +5071 1281 4 0 24.055596 -14.464366 6.446483 +5072 1281 4 0 22.714188 -14.794741 5.753275 +5073 1282 6 0 -26.337628 -13.401476 1.412480 +5074 1282 4 0 -26.098445 -12.489264 1.304520 +5075 1282 4 0 -25.434229 -13.739613 1.185013 +5076 1283 6 0 12.045641 6.334478 14.034491 +5077 1283 4 0 11.290237 6.052909 13.448299 +5078 1283 4 0 12.782332 5.993917 13.490639 +5079 1284 6 0 20.125812 -8.202150 -9.814098 +5080 1284 4 0 20.194536 -8.887766 -9.162911 +5081 1284 4 0 21.027215 -8.057148 -10.044296 +5082 1285 6 0 12.066525 -8.540938 -7.364209 +5083 1285 4 0 11.508583 -8.030746 -6.799426 +5084 1285 4 0 11.560454 -9.411302 -7.497328 +5085 1286 6 0 6.006584 -19.643391 -16.856771 +5086 1286 4 0 5.834004 -19.490315 -17.723180 +5087 1286 4 0 5.173445 -19.306940 -16.418662 +5088 1287 6 0 -26.105240 9.497668 11.035009 +5089 1287 4 0 -25.940506 10.208588 11.676762 +5090 1287 4 0 -26.907023 9.839249 10.688906 +5091 1288 6 0 25.980779 -10.760099 -17.043079 +5092 1288 4 0 26.294152 -9.947887 -17.408944 +5093 1288 4 0 26.659719 -11.433214 -17.294305 +5094 1289 6 0 17.405056 -19.269747 -14.944723 +5095 1289 4 0 17.214410 -18.409556 -14.434720 +5096 1289 4 0 17.526094 -19.972476 -14.301658 +5097 1290 6 0 -24.018604 17.625199 1.640879 +5098 1290 4 0 -24.784080 17.611175 1.083900 +5099 1290 4 0 -24.038354 18.437262 2.233960 +5100 1291 6 0 -19.713596 9.725034 11.241378 +5101 1291 4 0 -20.334881 9.562447 10.458947 +5102 1291 4 0 -18.859792 9.431551 10.874150 +5103 1292 6 0 12.017227 10.801952 4.275634 +5104 1292 4 0 11.431320 10.637434 5.045035 +5105 1292 4 0 11.407446 10.560420 3.532631 +5106 1293 6 0 -2.032321 -18.778706 7.677870 +5107 1293 4 0 -1.174746 -18.822855 7.226095 +5108 1293 4 0 -2.302104 -17.849324 7.787431 +5109 1294 6 0 27.376193 5.800091 -18.808667 +5110 1294 4 0 28.217784 5.560939 -18.324424 +5111 1294 4 0 27.470430 6.797809 -18.833583 +5112 1295 6 0 22.777052 -4.203723 15.528690 +5113 1295 4 0 22.819825 -4.163457 14.596219 +5114 1295 4 0 23.290333 -4.967303 15.841471 +5115 1296 6 0 -24.407041 -11.771935 -2.162786 +5116 1296 4 0 -24.850114 -12.297116 -2.844402 +5117 1296 4 0 -24.335332 -10.842961 -2.448771 +5118 1297 6 0 26.515383 14.863308 -11.949090 +5119 1297 4 0 25.693505 15.247676 -11.698157 +5120 1297 4 0 27.137639 14.903509 -11.237657 +5121 1298 6 0 9.526170 19.544584 -4.495947 +5122 1298 4 0 8.563440 19.681938 -4.310177 +5123 1298 4 0 9.710873 20.389152 -4.948099 +5124 1299 6 0 0.930640 14.865621 2.693375 +5125 1299 4 0 1.441052 15.216977 2.015262 +5126 1299 4 0 0.982855 15.427541 3.521397 +5127 1300 6 0 -8.560884 -14.779791 -0.317309 +5128 1300 4 0 -7.563132 -14.724309 -0.578447 +5129 1300 4 0 -8.944725 -15.346794 -1.006948 +5130 1301 6 0 -7.319722 -18.863858 -20.528347 +5131 1301 4 0 -8.028502 -18.663258 -21.126375 +5132 1301 4 0 -7.164500 -19.772394 -20.500444 +5133 1302 6 0 -15.128995 -19.691380 3.092730 +5134 1302 4 0 -16.008789 -19.690772 3.472840 +5135 1302 4 0 -14.968322 -20.623238 2.789294 +5136 1303 6 0 14.985700 14.931491 -8.447163 +5137 1303 4 0 15.394555 15.826269 -8.282486 +5138 1303 4 0 14.583931 14.705829 -7.592039 +5139 1304 6 0 27.322481 11.495061 -9.977404 +5140 1304 4 0 26.863175 12.062729 -9.353442 +5141 1304 4 0 28.126888 11.829690 -10.258173 +5142 1305 6 0 -18.229397 7.978168 7.639376 +5143 1305 4 0 -19.028971 7.438874 7.807107 +5144 1305 4 0 -17.575997 7.370338 7.232298 +5145 1306 6 0 -5.554901 9.643950 18.209130 +5146 1306 4 0 -4.877908 10.197790 17.765078 +5147 1306 4 0 -5.709375 10.290933 18.919059 +5148 1307 6 0 27.055810 -8.039157 10.769461 +5149 1307 4 0 27.007722 -8.570107 10.005081 +5150 1307 4 0 26.186325 -7.596689 10.673325 +5151 1308 6 0 11.193144 -4.443017 6.826722 +5152 1308 4 0 10.836891 -3.569010 6.720665 +5153 1308 4 0 12.137206 -4.292318 6.939554 +5154 1309 6 0 19.268222 19.404109 -20.005983 +5155 1309 4 0 18.552307 19.427583 -20.612317 +5156 1309 4 0 20.054546 19.443947 -20.508778 +5157 1310 6 0 -0.489608 2.918279 -19.339493 +5158 1310 4 0 -0.728227 3.023881 -20.237208 +5159 1310 4 0 0.435524 3.253135 -19.140478 +5160 1311 6 0 -9.930055 10.868000 -17.673601 +5161 1311 4 0 -10.626469 11.466271 -17.943644 +5162 1311 4 0 -9.408670 11.199903 -16.908283 +5163 1312 6 0 14.391665 -7.492360 -17.133433 +5164 1312 4 0 14.776095 -6.640715 -16.914336 +5165 1312 4 0 14.844935 -7.826758 -17.919613 +5166 1313 6 0 -4.403090 17.562294 4.304967 +5167 1313 4 0 -3.639926 17.895809 4.788467 +5168 1313 4 0 -4.847822 18.247386 3.881416 +5169 1314 6 0 14.924216 -8.572989 -7.802421 +5170 1314 4 0 15.080791 -9.001730 -8.577899 +5171 1314 4 0 14.072292 -8.888256 -7.443501 +5172 1315 6 0 20.863060 -8.335281 -2.996473 +5173 1315 4 0 20.865038 -7.834818 -2.195694 +5174 1315 4 0 20.360014 -9.121641 -2.844384 +5175 1316 6 0 7.770701 4.749626 -15.173810 +5176 1316 4 0 7.232605 4.918984 -14.407401 +5177 1316 4 0 7.150893 4.735931 -15.889673 +5178 1317 6 0 9.287502 -20.421293 -19.615918 +5179 1317 4 0 8.673901 -19.918813 -20.140368 +5180 1317 4 0 10.257214 -20.289398 -19.904230 +5181 1318 6 0 20.543914 -3.694600 8.858562 +5182 1318 4 0 20.350529 -3.346561 9.790355 +5183 1318 4 0 20.284447 -4.620852 8.950478 +5184 1319 6 0 -24.889469 -2.826087 -11.161559 +5185 1319 4 0 -24.617642 -1.952238 -10.677372 +5186 1319 4 0 -25.879679 -2.907043 -11.066325 +5187 1320 6 0 16.046200 -19.874001 -17.403642 +5188 1320 4 0 16.633402 -19.935906 -18.189298 +5189 1320 4 0 16.556861 -19.594522 -16.612102 +5190 1321 6 0 5.741718 -12.703855 14.460309 +5191 1321 4 0 6.418646 -13.226075 14.848859 +5192 1321 4 0 5.375423 -12.291966 15.251474 +5193 1322 6 0 -26.921124 3.080708 -16.683288 +5194 1322 4 0 -26.349288 3.764354 -17.076383 +5195 1322 4 0 -27.310492 3.610598 -15.940909 +5196 1323 6 0 -9.051861 -12.598891 -10.481740 +5197 1323 4 0 -9.312975 -13.202994 -11.160740 +5198 1323 4 0 -9.863453 -12.002119 -10.435649 +5199 1324 6 0 11.222934 -19.072403 -5.120308 +5200 1324 4 0 10.662322 -18.478568 -5.660022 +5201 1324 4 0 12.014749 -19.325909 -5.638718 +5202 1325 6 0 18.944446 -1.761496 -1.989981 +5203 1325 4 0 19.143872 -2.715939 -1.959282 +5204 1325 4 0 18.884717 -1.422297 -1.082916 +5205 1326 6 0 23.550316 -15.829708 -20.623087 +5206 1326 4 0 22.847013 -15.261005 -20.962532 +5207 1326 4 0 23.291254 -16.269725 -19.776352 +5208 1327 6 0 16.851801 5.388343 15.856452 +5209 1327 4 0 16.397949 5.383405 15.017945 +5210 1327 4 0 16.364224 6.131529 16.215918 +5211 1328 6 0 12.029283 -15.298450 15.005226 +5212 1328 4 0 11.752968 -15.998705 15.556968 +5213 1328 4 0 11.367704 -14.915688 14.430927 +5214 1329 6 0 14.340396 -0.486882 2.372215 +5215 1329 4 0 13.663877 -0.866715 2.885453 +5216 1329 4 0 14.313669 0.446574 2.655905 +5217 1330 6 0 -4.590564 -6.037942 9.321481 +5218 1330 4 0 -4.191484 -6.200341 8.445394 +5219 1330 4 0 -4.057284 -5.373615 9.813704 +5220 1331 6 0 11.373242 -19.244304 -15.042581 +5221 1331 4 0 12.222601 -19.509329 -15.419988 +5222 1331 4 0 10.727440 -19.492586 -15.694712 +5223 1332 6 0 8.445009 -7.353337 -20.644303 +5224 1332 4 0 8.065671 -6.779925 -19.985343 +5225 1332 4 0 8.109658 -8.330016 -20.463794 +5226 1333 6 0 9.428901 8.662531 -17.428301 +5227 1333 4 0 8.456111 8.645724 -17.644511 +5228 1333 4 0 9.529146 9.218358 -16.645571 +5229 1334 6 0 -22.387040 -19.582592 -7.404304 +5230 1334 4 0 -22.537521 -18.739332 -7.873166 +5231 1334 4 0 -22.150442 -19.339940 -6.528223 +5232 1335 6 0 26.735971 -15.726321 7.121648 +5233 1335 4 0 25.953722 -16.106883 7.512069 +5234 1335 4 0 26.460359 -14.804570 6.934323 +5235 1336 6 0 -20.988572 11.929476 3.968066 +5236 1336 4 0 -21.340596 11.563124 4.784938 +5237 1336 4 0 -21.130650 12.884161 4.069043 +5238 1337 6 0 21.473005 20.923952 -4.710755 +5239 1337 4 0 22.324172 21.375208 -4.753044 +5240 1337 4 0 21.707980 20.020307 -4.884522 +5241 1338 6 0 18.479193 -0.888136 0.672743 +5242 1338 4 0 17.536329 -0.750808 0.451811 +5243 1338 4 0 18.753176 -0.016644 0.847545 +5244 1339 6 0 -13.644220 -0.195942 -16.728164 +5245 1339 4 0 -14.145608 -0.971886 -16.514909 +5246 1339 4 0 -13.412704 -0.294150 -17.655379 +5247 1340 6 0 -27.356282 -13.782004 3.934427 +5248 1340 4 0 -27.242980 -13.845896 2.900565 +5249 1340 4 0 -28.015991 -14.339318 4.193014 +5250 1341 6 0 18.276550 10.521821 -10.411508 +5251 1341 4 0 17.466149 10.037966 -10.334512 +5252 1341 4 0 18.135131 11.463023 -10.441937 +5253 1342 6 0 11.304676 -3.958739 14.771873 +5254 1342 4 0 10.819571 -4.657592 14.338362 +5255 1342 4 0 11.872243 -4.302988 15.497743 +5256 1343 6 0 0.810718 18.132291 -14.333312 +5257 1343 4 0 0.190255 17.471051 -14.607576 +5258 1343 4 0 1.665202 17.681600 -14.166677 +5259 1344 6 0 -18.194302 10.734237 20.288216 +5260 1344 4 0 -18.737476 10.008872 20.011140 +5261 1344 4 0 -18.413412 10.870765 21.217524 +5262 1345 6 0 -7.563142 -16.389647 8.034997 +5263 1345 4 0 -7.754897 -16.237987 7.073421 +5264 1345 4 0 -8.386855 -16.715419 8.384876 +5265 1346 6 0 13.912058 -6.782117 15.996328 +5266 1346 4 0 13.180027 -7.276194 16.277557 +5267 1346 4 0 13.861231 -6.438577 15.112401 +5268 1347 6 0 -25.429958 -6.548345 16.184656 +5269 1347 4 0 -24.780220 -7.006450 16.697079 +5270 1347 4 0 -26.340485 -6.934525 16.332424 +5271 1348 6 0 -25.500783 -16.025799 -9.490569 +5272 1348 4 0 -26.164448 -16.158413 -8.820769 +5273 1348 4 0 -25.951236 -16.456932 -10.263221 +5274 1349 6 0 24.124222 2.121712 -16.465144 +5275 1349 4 0 24.497335 2.845246 -17.081218 +5276 1349 4 0 24.792485 1.399163 -16.373949 +5277 1350 6 0 4.547327 -7.471124 19.146289 +5278 1350 4 0 4.354864 -7.322111 18.216109 +5279 1350 4 0 3.632016 -7.470487 19.500477 +5280 1351 6 0 10.120616 17.236092 14.316409 +5281 1351 4 0 10.306027 17.503867 15.195486 +5282 1351 4 0 9.503499 17.802179 13.861569 +5283 1352 6 0 21.443686 -0.137574 -7.240239 +5284 1352 4 0 21.320909 -0.780264 -6.543039 +5285 1352 4 0 20.520021 0.052046 -7.411757 +5286 1353 6 0 -18.828207 -17.795055 12.603944 +5287 1353 4 0 -19.462622 -18.118613 13.289732 +5288 1353 4 0 -19.239011 -18.165303 11.770846 +5289 1354 6 0 -5.408698 18.602640 19.942387 +5290 1354 4 0 -4.940011 19.368098 19.546138 +5291 1354 4 0 -4.701861 17.940803 20.028319 +5292 1355 6 0 1.246630 7.058463 14.491223 +5293 1355 4 0 1.833210 6.855645 13.673367 +5294 1355 4 0 1.409024 6.330352 15.131330 +5295 1356 6 0 12.743100 -19.137500 -10.658143 +5296 1356 4 0 12.731029 -19.861558 -11.325766 +5297 1356 4 0 13.636140 -18.849862 -10.621111 +5298 1357 6 0 8.176227 18.621713 -14.093293 +5299 1357 4 0 8.403415 17.666902 -14.107193 +5300 1357 4 0 8.904018 18.994347 -14.634670 +5301 1358 6 0 -2.850169 -13.873152 15.306117 +5302 1358 4 0 -2.778021 -14.417883 14.515219 +5303 1358 4 0 -2.855607 -12.985119 14.927436 +5304 1359 6 0 -2.292558 -20.012333 10.080992 +5305 1359 4 0 -1.651194 -19.572426 10.625999 +5306 1359 4 0 -2.187742 -19.593458 9.218576 +5307 1360 6 0 22.331247 5.799873 2.670280 +5308 1360 4 0 22.434189 5.666649 3.628261 +5309 1360 4 0 22.776307 5.021312 2.347574 +5310 1361 6 0 15.417762 16.217823 -20.022192 +5311 1361 4 0 14.476316 16.148202 -19.889414 +5312 1361 4 0 15.596696 16.629517 -20.930968 +5313 1362 6 0 -26.290384 -0.615609 -8.011370 +5314 1362 4 0 -26.337180 -1.338819 -7.375398 +5315 1362 4 0 -27.197456 -0.506091 -8.331222 +5316 1363 6 0 9.027104 -10.649673 18.216586 +5317 1363 4 0 9.003116 -9.685060 18.321463 +5318 1363 4 0 8.395635 -11.040516 18.879208 +5319 1364 6 0 20.540085 20.400943 18.176526 +5320 1364 4 0 21.096121 20.661895 18.908831 +5321 1364 4 0 19.896888 21.145098 18.113813 +5322 1365 6 0 -1.026820 14.710767 -4.091506 +5323 1365 4 0 -1.483470 15.499879 -3.851169 +5324 1365 4 0 -1.334746 14.285611 -4.859625 +5325 1366 6 0 -26.089489 15.380454 18.855264 +5326 1366 4 0 -25.115552 15.260124 18.557693 +5327 1366 4 0 -26.107913 15.393677 19.825673 +5328 1367 6 0 2.007574 -16.086893 18.910154 +5329 1367 4 0 2.169938 -15.300051 18.371811 +5330 1367 4 0 1.765349 -16.777501 18.309170 +5331 1368 6 0 -1.731416 -1.209658 -17.616026 +5332 1368 4 0 -1.627324 -2.121913 -17.876677 +5333 1368 4 0 -0.897064 -0.759027 -17.856313 +5334 1369 6 0 -7.458988 -9.905611 -19.067646 +5335 1369 4 0 -7.612323 -9.236466 -18.379766 +5336 1369 4 0 -6.775597 -10.433737 -18.660285 +5337 1370 6 0 24.628885 -15.762187 -8.892475 +5338 1370 4 0 24.465618 -16.362594 -8.154270 +5339 1370 4 0 25.428263 -15.265529 -8.789821 +5340 1371 6 0 21.341678 17.087622 -2.433709 +5341 1371 4 0 22.027154 16.590055 -2.017304 +5342 1371 4 0 20.972791 17.595736 -1.703682 +5343 1372 6 0 11.041731 -1.458544 17.027146 +5344 1372 4 0 11.616990 -0.777488 17.323484 +5345 1372 4 0 11.529032 -2.030322 16.345409 +5346 1373 6 0 20.352182 -20.640448 -2.038220 +5347 1373 4 0 20.706451 -20.927732 -2.854198 +5348 1373 4 0 21.078721 -20.655585 -1.410115 +5349 1374 6 0 2.118915 -12.215325 -19.313844 +5350 1374 4 0 1.412292 -12.890446 -19.223921 +5351 1374 4 0 2.971726 -12.642687 -19.466619 +5352 1375 6 0 -18.234007 -11.608978 -6.453902 +5353 1375 4 0 -18.824060 -11.919205 -5.748304 +5354 1375 4 0 -17.399503 -12.148958 -6.321644 +5355 1376 6 0 12.956287 4.319222 -3.994225 +5356 1376 4 0 12.213046 3.674862 -3.908399 +5357 1376 4 0 12.579678 5.119154 -3.559136 +5358 1377 6 0 -16.653199 5.258818 18.455342 +5359 1377 4 0 -17.496007 5.121615 18.892108 +5360 1377 4 0 -16.041443 5.030868 19.126227 +5361 1378 6 0 10.499124 9.233410 -20.179160 +5362 1378 4 0 10.147585 9.358107 -19.280974 +5363 1378 4 0 11.442853 9.276973 -20.041862 +5364 1379 6 0 0.510441 -0.870953 17.320417 +5365 1379 4 0 1.102755 -1.566191 17.515002 +5366 1379 4 0 0.955429 -0.019852 17.557716 +5367 1380 6 0 4.110276 5.067141 6.431077 +5368 1380 4 0 4.761963 4.437776 6.681941 +5369 1380 4 0 4.337595 5.795548 6.948690 +5370 1381 6 0 11.452671 -16.505838 0.173069 +5371 1381 4 0 11.303683 -15.607972 0.510340 +5372 1381 4 0 12.391250 -16.653982 0.330533 +5373 1382 6 0 7.430077 -20.350208 8.105888 +5374 1382 4 0 7.675587 -20.672677 7.187383 +5375 1382 4 0 8.248925 -20.047358 8.520026 +5376 1383 6 0 -7.400434 16.364237 -16.666884 +5377 1383 4 0 -8.382471 16.160840 -16.727806 +5378 1383 4 0 -7.133812 16.815236 -17.541828 +5379 1384 6 0 -24.060814 19.512535 -2.061658 +5380 1384 4 0 -23.130977 19.418843 -1.893643 +5381 1384 4 0 -24.267554 20.363324 -2.551066 +5382 1385 6 0 20.387077 -17.871252 -2.506384 +5383 1385 4 0 19.459013 -17.739929 -2.640716 +5384 1385 4 0 20.424417 -18.802885 -2.422640 +5385 1386 6 0 -9.102927 -20.662897 -0.744511 +5386 1386 4 0 -8.351458 -20.647416 -0.154773 +5387 1386 4 0 -8.808769 -19.943254 -1.313754 +5388 1387 6 0 -22.416841 -13.711743 -11.454147 +5389 1387 4 0 -22.023904 -14.600414 -11.267420 +5390 1387 4 0 -21.766795 -13.100859 -11.064675 +5391 1388 6 0 18.020659 1.320207 -14.873666 +5392 1388 4 0 17.072103 1.602050 -14.789845 +5393 1388 4 0 18.329426 1.503733 -13.971877 +5394 1389 6 0 -15.611967 -16.933927 -20.034244 +5395 1389 4 0 -15.697544 -15.974880 -19.912529 +5396 1389 4 0 -16.463764 -17.241305 -19.666078 +5397 1390 6 0 -21.399563 -20.604313 -19.819242 +5398 1390 4 0 -22.286272 -20.451053 -20.149900 +5399 1390 4 0 -20.960242 -19.767241 -20.062136 +5400 1391 6 0 -14.873799 15.000585 15.755334 +5401 1391 4 0 -15.665375 14.566463 15.276438 +5402 1391 4 0 -15.221469 15.704608 16.223975 +5403 1392 6 0 -22.283717 17.924070 6.363117 +5404 1392 4 0 -22.326943 17.328611 7.088360 +5405 1392 4 0 -22.769780 17.540247 5.616208 +5406 1393 6 0 -4.518256 15.930815 -10.776370 +5407 1393 4 0 -3.722298 16.148281 -11.175263 +5408 1393 4 0 -4.440115 15.005875 -10.441712 +5409 1394 6 0 23.829242 -12.577808 -10.269253 +5410 1394 4 0 23.709620 -12.211859 -11.148216 +5411 1394 4 0 24.681269 -13.072156 -10.250620 +5412 1395 6 0 25.052401 -0.262291 -3.629356 +5413 1395 4 0 25.651051 -0.543026 -4.364585 +5414 1395 4 0 24.527612 0.474703 -4.021632 +5415 1396 6 0 14.329934 -16.440730 7.995977 +5416 1396 4 0 15.030052 -16.157725 7.466301 +5417 1396 4 0 13.674876 -16.863377 7.389073 +5418 1397 6 0 17.211657 20.746652 5.342912 +5419 1397 4 0 17.565761 20.264477 4.651199 +5420 1397 4 0 17.675222 21.576262 5.214762 +5421 1398 6 0 18.857835 10.961021 -18.198746 +5422 1398 4 0 18.582121 10.331224 -18.896135 +5423 1398 4 0 18.706900 11.843177 -18.451427 +5424 1399 6 0 7.806576 -0.529506 11.040094 +5425 1399 4 0 8.004288 -1.400200 11.405855 +5426 1399 4 0 8.516912 0.066000 11.339425 +5427 1400 6 0 -6.293411 -18.726760 -7.845237 +5428 1400 4 0 -6.910802 -18.996812 -8.589964 +5429 1400 4 0 -5.423066 -18.680010 -8.240732 +5430 1401 6 0 -1.265386 -18.351217 15.342196 +5431 1401 4 0 -0.978536 -17.941389 14.498149 +5432 1401 4 0 -1.776754 -19.060650 14.957444 +5433 1402 6 0 22.240898 5.630349 9.837319 +5434 1402 4 0 21.800731 4.901204 9.365178 +5435 1402 4 0 22.570414 6.163537 9.075972 +5436 1403 6 0 -21.322343 8.388055 9.072770 +5437 1403 4 0 -22.042357 8.964988 9.320991 +5438 1403 4 0 -21.568690 8.084477 8.201200 +5439 1404 6 0 -7.671244 -4.189475 20.344117 +5440 1404 4 0 -7.419567 -4.322104 19.418696 +5441 1404 4 0 -8.363860 -4.824728 20.370282 +5442 1405 6 0 -24.129456 16.739076 10.610161 +5443 1405 4 0 -24.547205 17.167468 11.404792 +5444 1405 4 0 -24.468711 15.757636 10.582819 +5445 1406 6 0 -6.867333 -14.186985 10.119152 +5446 1406 4 0 -6.049023 -14.321450 10.601875 +5447 1406 4 0 -7.023306 -14.804381 9.421465 +5448 1407 6 0 27.346506 -3.270333 -16.312802 +5449 1407 4 0 28.255175 -3.592935 -16.275175 +5450 1407 4 0 27.317511 -2.474622 -16.807450 +5451 1408 6 0 -21.641506 5.727852 -20.459813 +5452 1408 4 0 -22.279373 6.214532 -21.053396 +5453 1408 4 0 -20.775787 6.025886 -20.684218 +5454 1409 6 0 25.309710 5.144361 4.524619 +5455 1409 4 0 25.816635 5.036211 5.343240 +5456 1409 4 0 24.410878 4.895458 4.808645 +5457 1410 6 0 -14.509617 -6.262805 19.159506 +5458 1410 4 0 -14.342716 -6.722944 19.988985 +5459 1410 4 0 -14.602416 -5.323286 19.288859 +5460 1411 6 0 -5.343448 -11.274271 19.025798 +5461 1411 4 0 -4.940638 -11.918950 18.424498 +5462 1411 4 0 -5.498793 -11.715720 19.830266 +5463 1412 6 0 -12.848588 -13.590248 17.033609 +5464 1412 4 0 -13.088575 -13.796556 16.123304 +5465 1412 4 0 -11.991420 -14.074390 17.232742 +5466 1413 6 0 -7.289082 -17.381003 -5.549847 +5467 1413 4 0 -8.038865 -17.962440 -5.504293 +5468 1413 4 0 -6.970028 -17.592513 -6.445260 +5469 1414 6 0 19.348721 -14.932661 19.813219 +5470 1414 4 0 19.577232 -15.858745 19.765206 +5471 1414 4 0 18.713188 -14.720751 20.514547 +5472 1415 6 0 -7.930616 -15.106164 -4.397641 +5473 1415 4 0 -8.445836 -14.519877 -4.885728 +5474 1415 4 0 -7.532499 -15.797439 -4.932460 +5475 1416 6 0 9.305997 -17.229888 -1.625877 +5476 1416 4 0 9.781891 -17.999835 -2.038321 +5477 1416 4 0 10.027236 -16.701835 -1.179404 +5478 1417 6 0 14.485547 17.913855 14.273541 +5479 1417 4 0 13.775573 18.190913 13.687091 +5480 1417 4 0 15.292649 17.853242 13.696917 +5481 1418 6 0 -17.856749 -3.239166 18.728922 +5482 1418 4 0 -18.264266 -2.371813 18.585117 +5483 1418 4 0 -17.320266 -3.326693 17.906655 +5484 1419 6 0 11.415319 5.923359 -20.462324 +5485 1419 4 0 12.034713 5.464442 -19.848871 +5486 1419 4 0 10.982818 5.221175 -20.955049 +5487 1420 6 0 4.246715 -11.198844 16.227140 +5488 1420 4 0 4.054406 -10.449224 15.720401 +5489 1420 4 0 3.729643 -11.076561 16.998845 +5490 1421 6 0 17.668887 16.010513 -14.839435 +5491 1421 4 0 17.475048 15.032227 -14.810123 +5492 1421 4 0 17.201356 16.387530 -15.640949 +5493 1422 6 0 -18.492111 8.644500 -1.484673 +5494 1422 4 0 -18.325091 9.560921 -1.252627 +5495 1422 4 0 -19.325787 8.367546 -1.121513 +5496 1423 6 0 13.610401 12.947630 3.013371 +5497 1423 4 0 13.281039 12.533993 3.856655 +5498 1423 4 0 14.367204 13.456810 3.354976 +5499 1424 6 0 -16.423725 20.151070 -20.282392 +5500 1424 4 0 -15.764964 20.343494 -20.952998 +5501 1424 4 0 -17.250142 20.198658 -20.732026 +5502 1425 6 0 -3.989847 10.270724 -11.073966 +5503 1425 4 0 -3.495466 11.034119 -11.283995 +5504 1425 4 0 -4.624991 10.165649 -11.788271 +5505 1426 6 0 16.276806 2.440391 -0.575792 +5506 1426 4 0 15.765940 1.689695 -0.443195 +5507 1426 4 0 16.230870 2.461846 -1.548388 +5508 1427 6 0 16.582337 4.961920 -0.018366 +5509 1427 4 0 16.750405 4.953804 0.881833 +5510 1427 4 0 16.382476 4.092139 -0.296219 +5511 1428 6 0 -16.776801 -4.258809 -20.926631 +5512 1428 4 0 -16.876778 -3.694234 -21.711494 +5513 1428 4 0 -15.815010 -4.231038 -20.634779 +5514 1429 6 0 27.306315 1.909319 15.774251 +5515 1429 4 0 27.528797 1.213633 15.174474 +5516 1429 4 0 26.309168 1.894233 15.827646 +5517 1430 6 0 -25.977063 12.434586 -4.101907 +5518 1430 4 0 -25.419677 13.227991 -4.057872 +5519 1430 4 0 -25.558038 11.886611 -3.392245 +5520 1431 6 0 -8.917537 20.162429 18.906910 +5521 1431 4 0 -9.817722 20.516050 18.889155 +5522 1431 4 0 -8.402992 20.765622 18.322054 +5523 1432 6 0 2.036338 -3.225452 18.493289 +5524 1432 4 0 2.815627 -3.223614 19.047224 +5525 1432 4 0 1.451253 -3.554309 19.176609 +5526 1433 6 0 -10.943111 -16.939296 -15.943963 +5527 1433 4 0 -10.715338 -17.873691 -15.814810 +5528 1433 4 0 -11.411581 -16.839878 -16.774067 +5529 1434 6 0 5.983465 -15.296272 4.531445 +5530 1434 4 0 6.553908 -14.747320 5.130885 +5531 1434 4 0 6.297291 -16.216179 4.672680 +5532 1435 6 0 0.087877 -18.701863 10.933978 +5533 1435 4 0 0.685292 -18.178478 10.372593 +5534 1435 4 0 0.721975 -19.147274 11.528158 +5535 1436 6 0 -15.867197 20.628171 12.879631 +5536 1436 4 0 -14.941749 20.909539 13.127416 +5537 1436 4 0 -16.061214 21.005786 12.011063 +5538 1437 6 0 -15.031464 -1.955849 18.854814 +5539 1437 4 0 -15.381408 -1.375187 18.132775 +5540 1437 4 0 -15.567308 -1.774457 19.596007 +5541 1438 6 0 -5.713639 -18.898958 -11.393727 +5542 1438 4 0 -5.561092 -18.122829 -11.901780 +5543 1438 4 0 -5.027945 -19.039448 -10.715374 +5544 1439 6 0 10.351785 2.342628 9.137608 +5545 1439 4 0 10.219354 1.517524 8.764529 +5546 1439 4 0 9.579584 2.957546 9.024779 +5547 1440 6 0 9.614533 -0.976089 19.746830 +5548 1440 4 0 9.631955 -1.223467 18.785924 +5549 1440 4 0 10.037560 -1.819567 20.145752 +5550 1441 6 0 -25.737514 5.101092 17.496072 +5551 1441 4 0 -25.949189 4.771339 16.619275 +5552 1441 4 0 -25.460497 6.029342 17.333464 +5553 1442 6 0 27.098530 15.410179 3.235558 +5554 1442 4 0 27.365221 16.280617 3.273489 +5555 1442 4 0 27.777628 14.851248 3.682250 +5556 1443 6 0 -22.145578 -2.524811 -16.789026 +5557 1443 4 0 -22.476890 -1.687774 -16.973175 +5558 1443 4 0 -22.545487 -2.678464 -15.881093 +5559 1444 6 0 -20.038660 7.882073 -10.677168 +5560 1444 4 0 -20.786353 8.456789 -10.411968 +5561 1444 4 0 -20.303885 6.997195 -10.661212 +5562 1445 6 0 6.124673 -5.149502 -15.761404 +5563 1445 4 0 6.612667 -4.434874 -15.249053 +5564 1445 4 0 6.646658 -5.246066 -16.553355 +5565 1446 6 0 6.017362 -16.085801 -17.806752 +5566 1446 4 0 6.270539 -16.458116 -16.921098 +5567 1446 4 0 5.250388 -15.542937 -17.506389 +5568 1447 6 0 -9.374031 -17.523242 2.545572 +5569 1447 4 0 -8.487532 -17.678151 2.185352 +5570 1447 4 0 -9.361698 -17.695772 3.484410 +5571 1448 6 0 15.510564 11.705332 -9.223052 +5572 1448 4 0 15.764354 12.551003 -8.768718 +5573 1448 4 0 14.956013 11.971918 -9.941944 +5574 1449 6 0 -8.575937 17.703676 -4.431665 +5575 1449 4 0 -8.405924 17.883222 -3.539392 +5576 1449 4 0 -8.969679 16.778001 -4.495229 +5577 1450 6 0 -15.277037 20.916980 18.527990 +5578 1450 4 0 -14.557049 20.578200 18.029786 +5579 1450 4 0 -14.784644 21.516499 19.154300 +5580 1451 6 0 23.805081 -13.876618 -5.245218 +5581 1451 4 0 23.301003 -14.539959 -4.743943 +5582 1451 4 0 23.699048 -13.156658 -4.566103 +5583 1452 6 0 23.235009 0.659798 -11.019427 +5584 1452 4 0 23.356235 -0.020938 -10.331928 +5585 1452 4 0 23.922180 0.433479 -11.687400 +5586 1453 6 0 -17.846164 6.890268 -13.615475 +5587 1453 4 0 -18.227474 6.233852 -12.960353 +5588 1453 4 0 -17.502560 7.653333 -13.062645 +5589 1454 6 0 3.237690 6.611110 12.384611 +5590 1454 4 0 2.939622 6.791701 11.472608 +5591 1454 4 0 3.597050 5.706217 12.314107 +5592 1455 6 0 12.621261 19.151311 -10.788464 +5593 1455 4 0 12.568861 18.191071 -10.482080 +5594 1455 4 0 12.304890 19.095240 -11.710548 +5595 1456 6 0 15.189541 -3.590616 -0.359174 +5596 1456 4 0 15.402717 -3.225037 -1.223302 +5597 1456 4 0 15.977001 -4.068104 -0.090059 +5598 1457 6 0 -5.355594 -8.568333 19.641427 +5599 1457 4 0 -6.310615 -8.510356 19.969721 +5600 1457 4 0 -5.329970 -9.512642 19.277800 +5601 1458 6 0 6.365722 2.783749 -12.009649 +5602 1458 4 0 6.365749 3.750417 -12.183807 +5603 1458 4 0 5.965929 2.688579 -11.148102 +5604 1459 6 0 13.169614 -10.142007 -11.634557 +5605 1459 4 0 12.793149 -9.899166 -12.523960 +5606 1459 4 0 12.998542 -11.088881 -11.478349 +5607 1460 6 0 -22.674956 -9.666699 -16.999652 +5608 1460 4 0 -22.331812 -10.389941 -17.591652 +5609 1460 4 0 -22.299353 -8.906035 -17.478779 +5610 1461 6 0 -12.989714 14.562837 -4.489024 +5611 1461 4 0 -13.895012 14.141511 -4.581855 +5612 1461 4 0 -12.287469 13.906583 -4.558336 +5613 1462 6 0 11.889244 7.234465 -14.239933 +5614 1462 4 0 11.841540 6.403022 -13.699089 +5615 1462 4 0 11.297036 7.163549 -15.011709 +5616 1463 6 0 14.205425 -4.375072 6.885349 +5617 1463 4 0 14.444785 -3.467494 6.828421 +5618 1463 4 0 14.540396 -4.824463 6.047265 +5619 1464 6 0 14.238877 -11.199937 -5.844240 +5620 1464 4 0 14.336897 -11.151845 -6.791045 +5621 1464 4 0 14.161965 -12.124432 -5.730368 +5622 1465 6 0 16.419881 -8.263494 5.499713 +5623 1465 4 0 16.888087 -7.438031 5.380531 +5624 1465 4 0 16.938306 -8.794006 4.823282 +5625 1466 6 0 23.034740 17.150944 7.848428 +5626 1466 4 0 22.252785 17.491282 7.376162 +5627 1466 4 0 23.353461 18.012155 8.262400 +5628 1467 6 0 -3.250988 20.899767 -14.198279 +5629 1467 4 0 -3.536111 20.593819 -13.311678 +5630 1467 4 0 -2.238291 20.969313 -14.122183 +5631 1468 6 0 2.193864 -14.308738 -13.102332 +5632 1468 4 0 2.901120 -13.646677 -13.123464 +5633 1468 4 0 2.577942 -14.916050 -13.753214 +5634 1469 6 0 17.220878 14.344503 7.704982 +5635 1469 4 0 16.741444 14.217801 8.575501 +5636 1469 4 0 17.724190 13.489371 7.542738 +5637 1470 6 0 12.455324 8.941935 14.709279 +5638 1470 4 0 12.329532 7.965607 14.651692 +5639 1470 4 0 13.090154 8.950686 15.466000 +5640 1471 6 0 -12.573656 -3.849306 9.754915 +5641 1471 4 0 -11.774505 -4.059630 10.198532 +5642 1471 4 0 -13.177238 -3.385101 10.384533 +5643 1472 6 0 -3.160920 -11.557605 -13.637501 +5644 1472 4 0 -3.513108 -10.729378 -13.902906 +5645 1472 4 0 -2.423129 -11.640209 -14.202523 +5646 1473 6 0 0.173291 18.530627 4.588870 +5647 1473 4 0 0.366643 18.095665 3.775805 +5648 1473 4 0 0.528197 17.966406 5.256043 +5649 1474 6 0 -20.835824 0.618182 3.010345 +5650 1474 4 0 -21.714394 0.910710 2.556806 +5651 1474 4 0 -20.176134 1.018899 2.465288 +5652 1475 6 0 -5.819679 17.244537 -18.746988 +5653 1475 4 0 -4.895225 17.522561 -18.912967 +5654 1475 4 0 -5.875069 16.339088 -19.152521 +5655 1476 6 0 23.150756 6.504841 -18.289508 +5656 1476 4 0 23.185422 7.145655 -19.092606 +5657 1476 4 0 22.256620 6.278150 -18.023232 +5658 1477 6 0 11.077729 -17.823438 -12.637425 +5659 1477 4 0 11.305129 -18.418523 -13.399570 +5660 1477 4 0 11.718877 -18.045413 -11.962474 +5661 1478 6 0 -18.440076 4.089219 -20.233130 +5662 1478 4 0 -18.592368 4.508225 -19.389005 +5663 1478 4 0 -18.684565 4.808320 -20.850382 +5664 1479 6 0 -23.687711 -16.266769 -17.315735 +5665 1479 4 0 -23.698996 -15.631059 -16.558060 +5666 1479 4 0 -22.895860 -16.803598 -17.114489 +5667 1480 6 0 -12.383477 -18.880969 14.766217 +5668 1480 4 0 -12.124554 -18.562567 13.876588 +5669 1480 4 0 -11.797092 -18.625014 15.425543 +5670 1481 6 0 14.311125 11.668895 8.886321 +5671 1481 4 0 13.349519 11.381714 8.877659 +5672 1481 4 0 14.742001 11.037775 8.253125 +5673 1482 6 0 21.499156 2.133932 3.402465 +5674 1482 4 0 22.423113 2.229631 3.696856 +5675 1482 4 0 21.472059 1.349459 2.811378 +5676 1483 6 0 22.466695 -14.225899 -2.830703 +5677 1483 4 0 22.948700 -13.678947 -2.237715 +5678 1483 4 0 22.233121 -15.024736 -2.381007 +5679 1484 6 0 -17.714836 -8.402483 -11.856647 +5680 1484 4 0 -18.457906 -8.997855 -11.616200 +5681 1484 4 0 -16.950883 -8.800780 -11.389594 +5682 1485 6 0 -13.154395 20.875531 -1.901594 +5683 1485 4 0 -14.099007 20.684326 -1.676218 +5684 1485 4 0 -12.776951 21.273644 -1.137151 +5685 1486 6 0 10.058528 -10.804893 -19.659672 +5686 1486 4 0 10.024212 -10.944820 -18.690131 +5687 1486 4 0 9.262507 -10.364334 -19.857371 +5688 1487 6 0 24.206149 -6.530273 6.651758 +5689 1487 4 0 23.298132 -6.779979 6.469418 +5690 1487 4 0 24.435964 -6.280937 7.532499 +5691 1488 6 0 -0.769539 13.370711 18.754750 +5692 1488 4 0 -1.399471 13.295369 18.002641 +5693 1488 4 0 -1.282846 13.503163 19.578024 +5694 1489 6 0 12.489489 -16.824385 17.447916 +5695 1489 4 0 12.052693 -16.106503 17.961272 +5696 1489 4 0 12.979700 -17.322750 18.119196 +5697 1490 6 0 22.391449 -7.947848 18.889943 +5698 1490 4 0 22.777744 -7.558109 18.080179 +5699 1490 4 0 21.582771 -8.396208 18.531967 +5700 1491 6 0 24.444175 12.917036 5.832052 +5701 1491 4 0 24.511172 13.835523 6.045623 +5702 1491 4 0 23.797849 12.920835 5.128292 +5703 1492 6 0 13.404469 11.238393 -13.308046 +5704 1492 4 0 13.712479 10.420163 -13.763288 +5705 1492 4 0 12.688252 10.856036 -12.768343 +5706 1493 6 0 20.968072 -7.216860 -20.774585 +5707 1493 4 0 21.500932 -6.797898 -20.085206 +5708 1493 4 0 21.506305 -7.089210 -21.583804 +5709 1494 6 0 -17.856365 -7.389334 -15.755928 +5710 1494 4 0 -17.779099 -7.695814 -16.681187 +5711 1494 4 0 -17.454778 -6.543622 -15.646073 +5712 1495 6 0 -5.627767 -14.791821 -18.435422 +5713 1495 4 0 -6.515410 -14.559760 -18.598093 +5714 1495 4 0 -5.318446 -15.164242 -19.264852 +5715 1496 6 0 2.656405 -0.176950 -14.262302 +5716 1496 4 0 2.534896 -0.323212 -15.231477 +5717 1496 4 0 3.447328 0.360291 -14.052654 +5718 1497 6 0 -26.736151 5.658653 0.855763 +5719 1497 4 0 -25.877403 5.925247 0.635025 +5720 1497 4 0 -26.753355 4.689074 0.832778 +5721 1498 6 0 -8.652434 19.947608 -11.265190 +5722 1498 4 0 -8.042720 19.800388 -11.992106 +5723 1498 4 0 -8.377500 20.767189 -10.778181 +5724 1499 6 0 3.645772 -16.139913 -20.354692 +5725 1499 4 0 3.723824 -17.050742 -20.075710 +5726 1499 4 0 3.139128 -16.051183 -21.192748 +5727 1500 6 0 2.751218 19.096756 -12.278055 +5728 1500 4 0 3.589100 18.687062 -12.053483 +5729 1500 4 0 2.907368 19.432717 -13.149786 +5730 1501 6 0 11.895340 -6.132227 -17.645418 +5731 1501 4 0 12.272195 -6.990163 -17.614612 +5732 1501 4 0 12.522919 -5.533948 -18.055179 +5733 1502 6 0 -2.649062 -11.532506 14.303842 +5734 1502 4 0 -2.171418 -10.788172 14.727655 +5735 1502 4 0 -3.444108 -11.118837 14.016513 +5736 1503 6 0 0.083662 -17.539610 -9.794080 +5737 1503 4 0 0.925887 -17.184555 -10.098352 +5738 1503 4 0 0.064605 -17.230344 -8.891803 +5739 1504 6 0 -23.495878 -18.174487 -3.096140 +5740 1504 4 0 -23.397765 -18.550076 -2.214521 +5741 1504 4 0 -23.991094 -18.883389 -3.445375 +5742 1505 6 0 -2.870665 -20.299637 3.495989 +5743 1505 4 0 -2.025936 -20.316623 2.990845 +5744 1505 4 0 -2.887489 -19.480343 3.955086 +5745 1506 6 0 -23.237675 -7.968838 11.601659 +5746 1506 4 0 -23.646989 -7.664067 12.406714 +5747 1506 4 0 -22.916603 -8.875240 11.799352 +5748 1507 6 0 7.034857 17.671926 16.668461 +5749 1507 4 0 6.910916 17.021535 17.353714 +5750 1507 4 0 7.298259 17.003434 15.931912 +5751 1508 6 0 -3.135847 -0.037211 -19.720235 +5752 1508 4 0 -2.687204 -0.465713 -19.004635 +5753 1508 4 0 -3.883189 -0.596483 -19.830762 +5754 1509 6 0 -4.116282 9.933467 -15.972432 +5755 1509 4 0 -4.382486 10.098448 -16.874934 +5756 1509 4 0 -3.276586 10.322141 -15.857331 +5757 1510 6 0 9.001776 -2.037724 13.845066 +5758 1510 4 0 9.557925 -2.591779 14.385639 +5759 1510 4 0 8.707709 -2.619965 13.087293 +5760 1511 6 0 -14.291358 -16.357375 0.136544 +5761 1511 4 0 -14.623350 -16.546154 1.040530 +5762 1511 4 0 -13.337866 -16.185545 0.296606 +5763 1512 6 0 -8.307685 7.831957 -19.053875 +5764 1512 4 0 -8.711204 7.493084 -18.235703 +5765 1512 4 0 -7.891044 8.658915 -18.717398 +5766 1513 6 0 20.987462 12.906787 9.958048 +5767 1513 4 0 21.435148 12.305385 10.516693 +5768 1513 4 0 21.330938 12.746483 9.110616 +5769 1514 6 0 24.845310 0.514421 -13.306188 +5770 1514 4 0 24.715007 0.071792 -14.155230 +5771 1514 4 0 25.044193 1.459969 -13.507156 +5772 1515 6 0 9.940414 -19.224463 8.285169 +5773 1515 4 0 10.344194 -19.951358 7.833443 +5774 1515 4 0 9.604359 -18.739761 7.480563 +5775 1516 6 0 -21.714063 9.254293 -18.084261 +5776 1516 4 0 -21.666348 10.112348 -18.429358 +5777 1516 4 0 -20.881272 8.819770 -18.352190 +5778 1517 6 0 -7.191585 20.361392 -7.614111 +5779 1517 4 0 -7.827974 20.909525 -8.157675 +5780 1517 4 0 -7.763622 19.592347 -7.497909 +5781 1518 6 0 7.492921 13.497090 -0.820023 +5782 1518 4 0 7.499014 13.132441 -1.738485 +5783 1518 4 0 8.327452 13.163732 -0.446731 +5784 1519 6 0 9.961122 -18.299786 1.611143 +5785 1519 4 0 10.342232 -17.763270 0.893187 +5786 1519 4 0 9.632169 -19.079234 1.161105 +5787 1520 6 0 27.327916 14.167474 11.338410 +5788 1520 4 0 27.056501 14.797382 10.658423 +5789 1520 4 0 26.973899 14.521349 12.195671 +5790 1521 6 0 25.841592 -10.137073 17.886653 +5791 1521 4 0 26.549845 -10.744837 17.581594 +5792 1521 4 0 26.136382 -9.297891 18.115726 +5793 1522 6 0 -26.484582 -7.570640 0.220618 +5794 1522 4 0 -25.957551 -8.034324 0.885908 +5795 1522 4 0 -27.278989 -8.010770 0.092994 +5796 1523 6 0 -15.507886 -14.234567 -19.185887 +5797 1523 4 0 -16.428047 -14.062315 -19.146906 +5798 1523 4 0 -15.141693 -13.449414 -19.706261 +5799 1524 6 0 19.398920 -6.403154 -4.265132 +5800 1524 4 0 18.793855 -6.981438 -4.692992 +5801 1524 4 0 20.078652 -7.004436 -3.840081 +5802 1525 6 0 -14.727762 -11.689529 10.739544 +5803 1525 4 0 -15.118028 -11.677285 11.572442 +5804 1525 4 0 -15.363496 -11.211251 10.219303 +5805 1526 6 0 -10.164834 -13.429658 -5.821471 +5806 1526 4 0 -10.898604 -13.964191 -5.277591 +5807 1526 4 0 -10.251403 -12.561784 -5.414595 +5808 1527 6 0 17.930460 13.937399 -7.632026 +5809 1527 4 0 17.350338 14.712619 -7.873504 +5810 1527 4 0 17.573194 13.449935 -6.914302 +5811 1528 6 0 22.771963 11.789723 -15.991841 +5812 1528 4 0 22.407892 10.960756 -15.803516 +5813 1528 4 0 23.728244 11.844157 -15.970852 +5814 1529 6 0 -27.022171 -9.935535 -1.551898 +5815 1529 4 0 -26.648537 -9.163079 -1.958000 +5816 1529 4 0 -27.147733 -10.561946 -2.264608 +5817 1530 6 0 -25.271131 5.141749 -12.209736 +5818 1530 4 0 -25.693109 5.472145 -11.442865 +5819 1530 4 0 -24.406635 4.695966 -11.908321 +5820 1531 6 0 3.108121 -20.428019 2.767972 +5821 1531 4 0 2.883888 -19.516039 2.682074 +5822 1531 4 0 2.524652 -20.911289 2.151071 +5823 1532 6 0 13.645477 -11.248379 -2.168699 +5824 1532 4 0 14.495812 -10.982395 -1.919860 +5825 1532 4 0 13.602764 -10.946321 -3.131943 +5826 1533 6 0 -15.802101 -18.826697 -13.646876 +5827 1533 4 0 -15.629728 -18.718460 -14.634045 +5828 1533 4 0 -16.312937 -19.607220 -13.527508 +5829 1534 6 0 16.994190 -18.162501 0.782551 +5830 1534 4 0 16.183512 -18.419341 1.225144 +5831 1534 4 0 17.692383 -18.785460 1.112617 +5832 1535 6 0 0.346250 -8.244458 13.026523 +5833 1535 4 0 -0.056728 -8.794215 13.707605 +5834 1535 4 0 0.196186 -7.378794 13.513605 +5835 1536 6 0 -5.876633 -1.250758 16.950150 +5836 1536 4 0 -5.897139 -0.851532 16.048115 +5837 1536 4 0 -6.813697 -1.215101 17.207829 +5838 1537 6 0 -2.852852 -1.916845 15.179008 +5839 1537 4 0 -3.068812 -1.830206 16.106831 +5840 1537 4 0 -3.640384 -2.245054 14.797756 +5841 1538 6 0 -25.940841 -4.816621 -4.070316 +5842 1538 4 0 -25.207622 -5.264430 -3.620016 +5843 1538 4 0 -26.649933 -4.717697 -3.451686 +5844 1539 6 0 4.874827 1.473886 -14.337797 +5845 1539 4 0 5.189548 1.046518 -15.146140 +5846 1539 4 0 5.658759 1.677209 -13.804635 +5847 1540 6 0 -11.399492 -17.545168 -11.709535 +5848 1540 4 0 -10.632696 -17.968067 -12.065761 +5849 1540 4 0 -11.990484 -18.281339 -11.463174 +5850 1541 6 0 -21.235393 3.531686 -18.981903 +5851 1541 4 0 -20.811243 2.725219 -19.355158 +5852 1541 4 0 -21.330003 4.199180 -19.707403 +5853 1542 6 0 19.884738 13.457886 -16.503712 +5854 1542 4 0 20.546443 14.081854 -16.252605 +5855 1542 4 0 19.863325 12.725299 -15.889148 +5856 1543 6 0 -7.613490 -18.734979 -2.286157 +5857 1543 4 0 -7.224353 -19.383742 -2.870642 +5858 1543 4 0 -7.258594 -17.884019 -2.571812 +5859 1544 6 0 20.179247 18.669512 -9.520770 +5860 1544 4 0 19.745104 19.383705 -9.949059 +5861 1544 4 0 21.106271 18.888549 -9.619590 +5862 1545 6 0 0.469489 5.800556 -16.240608 +5863 1545 4 0 0.192512 6.630216 -16.696807 +5864 1545 4 0 0.599388 6.155641 -15.380452 +5865 1546 6 0 6.877961 19.550178 -9.988757 +5866 1546 4 0 6.368993 19.971864 -9.244013 +5867 1546 4 0 6.518231 19.965222 -10.851986 +5868 1547 6 0 6.720059 20.276251 -3.381777 +5869 1547 4 0 5.891426 20.783054 -3.333942 +5870 1547 4 0 6.919774 20.067477 -2.473444 +5871 1548 6 0 22.013148 -15.969229 12.266907 +5872 1548 4 0 21.416898 -16.484884 11.623216 +5873 1548 4 0 22.857478 -16.358079 12.000305 +5874 1549 6 0 -15.694438 7.944675 2.647767 +5875 1549 4 0 -15.370792 7.967212 3.559417 +5876 1549 4 0 -15.467715 7.066496 2.332465 +5877 1550 6 0 -25.016666 -19.872056 -7.507112 +5878 1550 4 0 -24.041389 -19.998563 -7.476847 +5879 1550 4 0 -25.261819 -19.677629 -8.458935 +5880 1551 6 0 -17.404966 16.289559 0.378862 +5881 1551 4 0 -17.816202 15.395796 0.469359 +5882 1551 4 0 -16.592061 16.078371 -0.128857 +5883 1552 6 0 11.719854 13.896915 -20.007550 +5884 1552 4 0 11.762017 13.509054 -20.946443 +5885 1552 4 0 11.730057 13.211150 -19.340581 +5886 1553 6 0 -21.635289 10.922735 -14.289364 +5887 1553 4 0 -22.250180 11.585121 -14.648600 +5888 1553 4 0 -20.920683 10.786571 -14.961527 +5889 1554 6 0 -24.042065 -5.374879 10.098466 +5890 1554 4 0 -23.939428 -5.512490 9.105496 +5891 1554 4 0 -23.970753 -6.321333 10.460122 +5892 1555 6 0 -9.411597 6.559490 -16.669992 +5893 1555 4 0 -10.312323 6.551498 -16.403482 +5894 1555 4 0 -9.011995 5.640085 -16.634798 +5895 1556 6 0 9.530893 -11.884062 12.046782 +5896 1556 4 0 9.879650 -11.398694 11.280896 +5897 1556 4 0 9.261341 -11.231618 12.651989 +5898 1557 6 0 -1.911349 -16.933894 1.374617 +5899 1557 4 0 -2.219904 -17.739022 1.023023 +5900 1557 4 0 -1.747381 -16.334388 0.676612 +5901 1558 6 0 26.179381 -17.174136 0.502901 +5902 1558 4 0 25.703357 -17.150578 -0.364558 +5903 1558 4 0 25.879759 -16.529513 1.122222 +5904 1559 6 0 23.006008 2.418768 11.548952 +5905 1559 4 0 22.123244 2.196506 11.872833 +5906 1559 4 0 22.916266 2.423276 10.570078 +5907 1560 6 0 -25.061378 12.895337 -10.920642 +5908 1560 4 0 -24.236859 12.794849 -10.380539 +5909 1560 4 0 -24.844809 13.124176 -11.856801 +5910 1561 6 0 24.065450 16.186345 -1.562209 +5911 1561 4 0 23.818077 16.816733 -0.921419 +5912 1561 4 0 24.446065 16.798992 -2.179306 +5913 1562 6 0 21.877525 -11.997066 12.743827 +5914 1562 4 0 21.110101 -12.307846 12.276099 +5915 1562 4 0 21.795852 -11.028569 12.668947 +5916 1563 6 0 -9.770390 12.275988 6.625277 +5917 1563 4 0 -9.540551 11.529014 6.118639 +5918 1563 4 0 -9.063347 12.943993 6.639152 +5919 1564 6 0 7.590434 -16.518614 -3.885689 +5920 1564 4 0 8.245405 -16.780602 -4.602660 +5921 1564 4 0 8.060783 -16.730529 -3.006396 +5922 1565 6 0 -8.819809 7.819937 16.686859 +5923 1565 4 0 -8.459184 7.862962 15.781131 +5924 1565 4 0 -8.333215 7.208627 17.206742 +5925 1566 6 0 -0.018770 12.851916 7.726452 +5926 1566 4 0 -0.018534 13.815629 7.654360 +5927 1566 4 0 -0.678950 12.568762 8.379340 +5928 1567 6 0 26.935998 -2.260542 -4.734090 +5929 1567 4 0 27.692757 -2.309847 -5.350797 +5930 1567 4 0 27.186636 -2.518573 -3.802021 +5931 1568 6 0 27.034878 8.922183 -3.893061 +5932 1568 4 0 26.315953 9.520583 -3.776301 +5933 1568 4 0 27.485194 9.316156 -4.684455 +5934 1569 6 0 8.051349 7.651612 -11.998393 +5935 1569 4 0 8.628507 7.928025 -11.260450 +5936 1569 4 0 7.748144 8.473350 -12.355271 +5937 1570 6 0 -27.116258 -14.053521 12.105107 +5938 1570 4 0 -27.545532 -13.197780 12.384888 +5939 1570 4 0 -26.358772 -13.875946 11.579879 +5940 1571 6 0 23.554783 -11.406323 -3.754207 +5941 1571 4 0 24.096179 -11.152033 -2.997418 +5942 1571 4 0 23.941749 -11.074873 -4.532762 +5943 1572 6 0 -6.910654 -17.603975 17.334387 +5944 1572 4 0 -7.702761 -17.167889 17.745512 +5945 1572 4 0 -6.836320 -17.171292 16.454588 +5946 1573 6 0 -16.492037 5.302939 -1.579501 +5947 1573 4 0 -16.042514 4.646869 -2.112816 +5948 1573 4 0 -15.801804 6.017062 -1.587499 +5949 1574 6 0 -23.756350 3.926953 -8.179925 +5950 1574 4 0 -23.195167 4.286584 -8.893370 +5951 1574 4 0 -23.460247 3.034235 -7.983373 +5952 1575 6 0 -13.747357 8.818643 -3.799589 +5953 1575 4 0 -13.952688 8.414506 -2.934484 +5954 1575 4 0 -13.853214 9.757832 -3.600478 +5955 1576 6 0 -1.628128 -12.816264 -17.331527 +5956 1576 4 0 -2.433523 -13.356344 -17.119883 +5957 1576 4 0 -2.044696 -11.950129 -17.560931 +5958 1577 6 0 -0.085635 15.544048 -1.201911 +5959 1577 4 0 -0.000781 16.405004 -1.546695 +5960 1577 4 0 -0.971991 15.289121 -0.919162 +5961 1578 6 0 -8.590554 17.067218 -10.033341 +5962 1578 4 0 -8.478641 17.979748 -10.381694 +5963 1578 4 0 -9.177179 16.660222 -10.710438 +5964 1579 6 0 -18.092032 -16.862277 -18.860686 +5965 1579 4 0 -17.787112 -16.936281 -17.986509 +5966 1579 4 0 -18.687545 -17.567560 -19.061403 +5967 1580 6 0 11.369215 4.413430 15.924887 +5968 1580 4 0 11.372520 3.624729 15.359827 +5969 1580 4 0 11.705477 5.119414 15.321428 +5970 1581 6 0 12.784492 7.071253 19.464041 +5971 1581 4 0 12.860418 6.279814 18.965525 +5972 1581 4 0 12.277088 6.716268 20.219705 +5973 1582 6 0 12.068135 -8.262908 17.552171 +5974 1582 4 0 11.944483 -7.791072 18.350772 +5975 1582 4 0 12.525141 -9.091659 17.770424 +5976 1583 6 0 10.241854 4.742923 2.559332 +5977 1583 4 0 9.423895 4.504759 2.987600 +5978 1583 4 0 10.968724 4.120073 2.820528 +5979 1584 6 0 4.587851 -5.032891 12.160556 +5980 1584 4 0 4.431505 -4.242508 12.621627 +5981 1584 4 0 5.402359 -4.988575 11.647199 +5982 1585 6 0 -24.230874 -6.577818 -16.070853 +5983 1585 4 0 -23.682020 -6.608606 -15.296098 +5984 1585 4 0 -25.097764 -7.040376 -15.909446 +5985 1586 6 0 20.182613 7.158966 1.874949 +5986 1586 4 0 20.915498 6.541606 2.146531 +5987 1586 4 0 20.710894 7.927513 1.477203 +5988 1587 6 0 21.755390 6.896132 -12.917138 +5989 1587 4 0 22.076449 7.236600 -12.089303 +5990 1587 4 0 22.525120 6.527089 -13.344666 +5991 1588 6 0 6.877822 -4.771079 6.941634 +5992 1588 4 0 7.368474 -3.917167 6.794895 +5993 1588 4 0 6.561555 -4.815923 7.876455 +5994 1589 6 0 -17.794941 18.359853 16.305117 +5995 1589 4 0 -18.421394 18.650198 16.927781 +5996 1589 4 0 -17.650629 19.254815 15.811542 +5997 1590 6 0 -2.602624 -16.412046 -10.596632 +5998 1590 4 0 -2.730413 -15.479270 -10.244360 +5999 1590 4 0 -1.636947 -16.665956 -10.610129 +6000 1591 6 0 3.935143 -2.077202 16.379950 +6001 1591 4 0 3.116180 -2.074570 16.871393 +6002 1591 4 0 4.258130 -3.011541 16.214763 +6003 1592 6 0 26.054987 14.635245 18.309718 +6004 1592 4 0 27.012144 14.531484 18.422001 +6005 1592 4 0 25.883129 15.612156 18.232382 +6006 1593 6 0 22.186055 -2.285036 -18.276384 +6007 1593 4 0 22.575561 -1.490206 -18.592190 +6008 1593 4 0 21.774977 -1.952262 -17.452519 +6009 1594 6 0 5.982701 12.874655 -19.536076 +6010 1594 4 0 6.160786 13.198075 -20.428652 +6011 1594 4 0 6.854019 12.668623 -19.180374 +6012 1595 6 0 -6.054158 -13.744402 -7.200732 +6013 1595 4 0 -6.689102 -14.438760 -7.467162 +6014 1595 4 0 -5.241683 -14.218938 -7.253580 +6015 1596 6 0 7.766648 -19.472206 -8.674412 +6016 1596 4 0 7.994143 -19.850740 -7.811770 +6017 1596 4 0 7.159819 -20.051349 -9.144842 +6018 1597 6 0 -13.899693 -2.310609 11.719170 +6019 1597 4 0 -14.293895 -1.540339 11.338780 +6020 1597 4 0 -13.136046 -1.840341 12.108102 +6021 1598 6 0 26.880118 -3.988040 -2.564260 +6022 1598 4 0 27.141785 -3.912376 -1.619664 +6023 1598 4 0 25.991507 -4.403119 -2.509330 +6024 1599 6 0 16.831698 -0.370079 16.786168 +6025 1599 4 0 17.550555 0.178386 16.456695 +6026 1599 4 0 17.096485 -0.465948 17.715552 +6027 1600 6 0 19.019953 8.994801 17.672825 +6028 1600 4 0 18.825567 9.927341 17.839722 +6029 1600 4 0 19.072225 8.455310 18.528449 +6030 1601 6 0 -23.890734 -17.531047 20.103131 +6031 1601 4 0 -24.410048 -17.249588 20.880036 +6032 1601 4 0 -23.243461 -16.838233 19.952601 +6033 1602 6 0 24.612082 6.311703 -14.314049 +6034 1602 4 0 24.685511 6.721117 -15.194578 +6035 1602 4 0 24.456182 5.357259 -14.330432 +6036 1603 6 0 11.630912 5.335794 8.212450 +6037 1603 4 0 10.744689 5.096999 8.355771 +6038 1603 4 0 11.632399 6.142908 7.660144 +6039 1604 6 0 16.482829 -7.676138 17.246704 +6040 1604 4 0 15.832973 -7.172968 16.764273 +6041 1604 4 0 17.323015 -7.087522 17.068424 +6042 1605 6 0 -14.246850 -1.445493 8.521283 +6043 1605 4 0 -14.965431 -1.234868 9.098827 +6044 1605 4 0 -14.565647 -2.243574 8.052945 +6045 1606 6 0 -12.243735 5.878745 14.287709 +6046 1606 4 0 -12.931194 5.878071 14.927194 +6047 1606 4 0 -12.476832 5.118118 13.758795 +6048 1607 6 0 14.365931 -20.845025 6.067181 +6049 1607 4 0 14.538057 -20.237448 6.808442 +6050 1607 4 0 15.204917 -21.078698 5.761047 +6051 1608 6 0 16.298718 -4.138023 18.121710 +6052 1608 4 0 15.424215 -3.680129 18.372722 +6053 1608 4 0 16.684549 -4.205202 19.001012 +6054 1609 6 0 -14.198508 -14.194772 -14.794207 +6055 1609 4 0 -13.444357 -14.590983 -14.343955 +6056 1609 4 0 -13.774495 -13.612371 -15.434882 +6057 1610 6 0 -10.030484 -15.925396 14.049869 +6058 1610 4 0 -9.661016 -16.753356 13.643301 +6059 1610 4 0 -9.506338 -15.169357 13.752939 +6060 1611 6 0 2.620657 -7.959507 -20.667278 +6061 1611 4 0 2.062110 -7.160386 -20.605865 +6062 1611 4 0 2.138798 -8.553220 -21.271787 +6063 1612 6 0 5.778060 4.436909 12.837835 +6064 1612 4 0 5.362329 3.721975 13.322111 +6065 1612 4 0 5.808629 5.246373 13.380366 +6066 1613 6 0 16.866472 5.920215 7.405820 +6067 1613 4 0 16.435352 5.086965 7.209575 +6068 1613 4 0 16.163833 6.543037 7.470100 +6069 1614 6 0 17.825944 -3.501642 -5.065436 +6070 1614 4 0 17.700510 -2.538825 -4.863235 +6071 1614 4 0 18.532466 -3.602326 -5.702852 +6072 1615 6 0 -11.681593 20.597292 5.432499 +6073 1615 4 0 -11.969564 21.510542 5.152859 +6074 1615 4 0 -12.562576 20.147115 5.430236 +6075 1616 6 0 21.531845 -18.609965 -11.465553 +6076 1616 4 0 21.036885 -18.970566 -10.752405 +6077 1616 4 0 20.911041 -18.252243 -12.167168 +6078 1617 6 0 0.249866 -13.875504 -5.737561 +6079 1617 4 0 1.053242 -14.152812 -5.334020 +6080 1617 4 0 0.540234 -13.078009 -6.238789 +6081 1618 6 0 3.047539 17.051565 11.568254 +6082 1618 4 0 3.164343 17.306128 12.474589 +6083 1618 4 0 2.524042 17.779795 11.213697 +6084 1619 6 0 24.178795 -4.873391 -17.954897 +6085 1619 4 0 23.609912 -4.083965 -18.078992 +6086 1619 4 0 24.401168 -4.923489 -16.992528 +6087 1620 6 0 3.954939 20.513379 -14.418517 +6088 1620 4 0 3.581046 20.093104 -15.154897 +6089 1620 4 0 3.811800 21.468596 -14.662255 +6090 1621 6 0 -0.149556 2.777227 -12.291758 +6091 1621 4 0 -0.121223 2.435369 -11.351012 +6092 1621 4 0 0.596183 3.441893 -12.318897 +6093 1622 6 0 27.193112 8.418341 -10.172198 +6094 1622 4 0 26.787164 8.259494 -11.042944 +6095 1622 4 0 27.410726 9.433106 -10.260356 +6096 1623 6 0 -24.022975 1.655208 -11.524687 +6097 1623 4 0 -24.291048 0.824835 -11.888466 +6098 1623 4 0 -24.881489 1.940641 -11.171341 +6099 1624 6 0 26.405280 -5.462847 -5.065504 +6100 1624 4 0 26.209462 -6.029181 -5.803215 +6101 1624 4 0 27.373218 -5.317034 -5.077630 +6102 1625 6 0 -3.690721 10.045789 -20.208648 +6103 1625 4 0 -4.248266 9.317998 -19.851069 +6104 1625 4 0 -2.834866 9.590938 -20.465215 +6105 1626 6 0 -2.559171 12.379195 -18.651596 +6106 1626 4 0 -3.295406 13.039384 -18.601178 +6107 1626 4 0 -2.957289 11.575659 -18.948915 +6108 1627 6 0 9.997514 -3.540058 20.611729 +6109 1627 4 0 9.428623 -3.673422 21.365363 +6110 1627 4 0 10.919581 -3.718379 20.892643 +6111 1628 6 0 22.711145 -8.644902 0.632604 +6112 1628 4 0 23.670226 -8.511619 0.628432 +6113 1628 4 0 22.493868 -9.498519 0.275412 +6114 1629 6 0 14.085903 -1.038370 -16.414394 +6115 1629 4 0 14.059869 -1.196217 -15.467296 +6116 1629 4 0 13.262318 -1.459953 -16.715075 +6117 1630 6 0 -12.216643 15.094727 14.953780 +6118 1630 4 0 -11.931679 15.769402 14.281719 +6119 1630 4 0 -13.149517 15.224147 15.123844 +6120 1631 6 0 -24.757277 7.231003 8.542276 +6121 1631 4 0 -24.784189 8.210199 8.450823 +6122 1631 4 0 -24.549551 6.922193 9.397707 +6123 1632 6 0 3.372929 19.847026 -0.606151 +6124 1632 4 0 3.191569 19.283633 -1.369340 +6125 1632 4 0 4.347642 20.010416 -0.683022 +6126 1633 6 0 8.872330 -16.761760 17.202410 +6127 1633 4 0 8.996558 -17.151460 16.293393 +6128 1633 4 0 9.700285 -17.024144 17.621618 +6129 1634 6 0 9.343569 14.953908 -19.877613 +6130 1634 4 0 9.005091 14.803515 -18.977870 +6131 1634 4 0 10.168474 14.477496 -19.931351 +6132 1635 6 0 2.034725 4.776928 20.854933 +6133 1635 4 0 2.700859 5.449702 20.919206 +6134 1635 4 0 1.289075 5.153942 21.314556 +6135 1636 6 0 18.285982 7.046313 3.854888 +6136 1636 4 0 18.754091 7.109170 3.047358 +6137 1636 4 0 18.852898 6.489134 4.447893 +6138 1637 6 0 17.000427 19.166068 19.844454 +6139 1637 4 0 17.780774 18.891038 19.347291 +6140 1637 4 0 16.338665 18.528198 19.533743 +6141 1638 6 0 4.309924 6.553220 -20.552969 +6142 1638 4 0 4.375422 6.917713 -21.455723 +6143 1638 4 0 5.249758 6.290930 -20.364274 +6144 1639 6 0 20.777753 -4.985339 -6.248152 +6145 1639 4 0 20.286399 -4.821264 -7.053768 +6146 1639 4 0 20.234568 -5.537952 -5.671124 +6147 1640 6 0 4.730675 15.020276 -10.674086 +6148 1640 4 0 4.376943 14.834207 -9.767214 +6149 1640 4 0 4.726770 15.973286 -10.733237 +6150 1641 6 0 2.355355 1.234033 17.572616 +6151 1641 4 0 3.034023 1.365267 16.849468 +6152 1641 4 0 1.929729 2.103871 17.645246 +6153 1642 6 0 -20.364763 -10.341423 19.798444 +6154 1642 4 0 -20.097141 -9.967826 18.943902 +6155 1642 4 0 -20.518570 -9.582890 20.375779 +6156 1643 6 0 24.191317 -20.301143 13.503559 +6157 1643 4 0 25.075667 -20.080336 13.914227 +6158 1643 4 0 23.551864 -19.853712 14.034970 +6159 1644 6 0 -17.771965 -0.812840 5.691659 +6160 1644 4 0 -17.110001 -0.172585 5.922995 +6161 1644 4 0 -18.609271 -0.533119 5.998788 +6162 1645 6 0 8.428411 7.992467 20.234546 +6163 1645 4 0 9.349683 8.062329 20.534745 +6164 1645 4 0 7.930578 8.665863 20.632958 +6165 1646 6 0 14.933965 18.875827 -5.159997 +6166 1646 4 0 14.094884 19.194527 -5.500018 +6167 1646 4 0 15.603425 19.608364 -5.196749 +6168 1647 6 0 -11.010909 -1.265131 18.652423 +6169 1647 4 0 -11.027649 -1.155636 17.705218 +6170 1647 4 0 -10.091875 -1.091225 18.938417 +6171 1648 6 0 -21.191413 -9.651017 -4.562795 +6172 1648 4 0 -20.962638 -9.680538 -5.508642 +6173 1648 4 0 -20.795476 -10.416878 -4.182448 +6174 1649 6 0 5.099725 -12.626597 -17.884817 +6175 1649 4 0 5.666927 -12.400935 -17.105607 +6176 1649 4 0 4.764175 -11.785457 -18.184293 +6177 1650 6 0 -21.388510 -5.492100 10.971049 +6178 1650 4 0 -22.216480 -5.626371 10.534286 +6179 1650 4 0 -21.551676 -5.367629 11.909886 +6180 1651 6 0 -26.689928 -8.293398 13.111418 +6181 1651 4 0 -27.003954 -8.182450 12.219010 +6182 1651 4 0 -26.900928 -9.235390 13.263182 +6183 1652 6 0 6.162303 19.062401 -17.622686 +6184 1652 4 0 5.955026 19.807434 -17.095725 +6185 1652 4 0 6.287880 18.311383 -17.062421 +6186 1653 6 0 -26.568944 19.936247 1.863051 +6187 1653 4 0 -26.429552 19.451776 1.050937 +6188 1653 4 0 -25.730651 20.069282 2.308590 +6189 1654 6 0 -12.939452 -17.938569 9.558916 +6190 1654 4 0 -12.598970 -18.093496 10.439491 +6191 1654 4 0 -13.201371 -18.755858 9.152488 +6192 1655 6 0 -11.464685 7.314998 -14.468616 +6193 1655 4 0 -12.254067 7.075040 -13.971198 +6194 1655 4 0 -11.784844 7.883355 -15.166065 +6195 1656 6 0 20.495565 -8.915532 9.256247 +6196 1656 4 0 19.761356 -9.177749 9.963841 +6197 1656 4 0 20.333767 -7.961456 9.244216 +6198 1657 6 0 -16.958223 -6.637117 15.942724 +6199 1657 4 0 -17.590511 -6.925764 15.256778 +6200 1657 4 0 -17.006530 -7.309307 16.639627 +6201 1658 6 0 -7.465242 20.880802 3.955458 +6202 1658 4 0 -6.906639 21.395406 3.368693 +6203 1658 4 0 -7.384772 21.435308 4.777200 +6204 1659 6 0 10.987484 -10.220761 -0.486092 +6205 1659 4 0 11.657995 -10.039232 -1.157052 +6206 1659 4 0 10.134305 -10.217278 -0.922065 +6207 1660 6 0 -11.745045 12.656305 2.561380 +6208 1660 4 0 -12.067404 12.975187 3.387647 +6209 1660 4 0 -11.009457 12.085090 2.865904 +6210 1661 6 0 -5.579572 -16.497607 -20.750701 +6211 1661 4 0 -4.847773 -16.621590 -21.371280 +6212 1661 4 0 -6.034567 -17.358476 -20.680344 +6213 1662 6 0 1.964841 -7.772342 -15.446535 +6214 1662 4 0 2.789953 -8.261174 -15.222416 +6215 1662 4 0 1.224980 -8.401255 -15.497885 +6216 1663 6 0 17.133687 20.836195 -5.235713 +6217 1663 4 0 16.963395 21.728366 -4.832203 +6218 1663 4 0 18.061664 20.710791 -5.306008 +6219 1664 6 0 -18.390780 10.973515 3.704388 +6220 1664 4 0 -19.253132 11.409402 3.769882 +6221 1664 4 0 -18.035350 10.771168 4.577357 +6222 1665 6 0 14.221292 20.673222 -19.936970 +6223 1665 4 0 13.920637 20.243897 -20.741067 +6224 1665 4 0 14.685112 21.462779 -20.332088 +6225 1666 6 0 -21.084831 12.253935 9.565359 +6226 1666 4 0 -20.600168 11.482007 9.886149 +6227 1666 4 0 -21.728096 12.542158 10.140605 +6228 1667 6 0 21.807475 -0.416214 2.152466 +6229 1667 4 0 22.039987 -0.306167 1.206900 +6230 1667 4 0 22.400722 -1.068057 2.516791 +6231 1668 6 0 20.924050 10.441338 14.208356 +6232 1668 4 0 21.615541 10.869208 14.797933 +6233 1668 4 0 20.771960 9.540413 14.573568 +6234 1669 6 0 6.259921 4.454937 -17.265429 +6235 1669 4 0 6.706330 4.203652 -18.064753 +6236 1669 4 0 5.711163 3.710753 -17.001578 +6237 1670 6 0 -4.214022 14.596706 -18.431597 +6238 1670 4 0 -3.688756 15.025866 -17.718188 +6239 1670 4 0 -5.088033 14.473133 -18.084790 +6240 1671 6 0 -2.199419 13.906578 9.672426 +6241 1671 4 0 -2.129396 13.038932 9.992785 +6242 1671 4 0 -3.120153 14.058476 9.477073 +6243 1672 6 0 9.044748 2.046702 -11.991573 +6244 1672 4 0 9.465655 2.820071 -11.709794 +6245 1672 4 0 8.080161 2.265383 -12.092250 +6246 1673 6 0 7.143894 -11.920235 -15.669336 +6247 1673 4 0 6.531119 -11.505986 -15.060545 +6248 1673 4 0 7.414267 -12.765754 -15.195832 +6249 1674 6 0 -5.826228 -0.168688 14.337506 +6250 1674 4 0 -5.465882 -0.527232 13.513436 +6251 1674 4 0 -5.608854 0.802946 14.323569 +6252 1675 6 0 5.648885 3.826675 19.190577 +6253 1675 4 0 5.186784 3.361795 19.925791 +6254 1675 4 0 5.056212 3.823989 18.450900 +6255 1676 6 0 9.326815 -6.082614 -17.012500 +6256 1676 4 0 10.201835 -6.094812 -17.433769 +6257 1676 4 0 9.461714 -5.493002 -16.251384 +6258 1677 6 0 -1.961522 -12.154184 11.549933 +6259 1677 4 0 -1.624684 -11.469274 10.968619 +6260 1677 4 0 -2.192863 -11.701664 12.378278 +6261 1678 6 0 22.610380 9.966271 5.674665 +6262 1678 4 0 23.383558 10.326639 6.158091 +6263 1678 4 0 22.639822 10.376867 4.833334 +6264 1679 6 0 -15.460748 19.613439 2.679694 +6265 1679 4 0 -16.411896 19.506793 2.586178 +6266 1679 4 0 -14.953260 19.393944 1.878689 +6267 1680 6 0 -9.915773 -6.329847 7.803991 +6268 1680 4 0 -9.882720 -5.651785 8.461110 +6269 1680 4 0 -10.460430 -6.991760 8.214687 +6270 1681 6 0 -25.207118 14.245870 9.965310 +6271 1681 4 0 -24.983683 14.155643 9.024696 +6272 1681 4 0 -26.142233 13.940881 10.004034 +6273 1682 6 0 -25.736790 -11.761067 -20.022820 +6274 1682 4 0 -25.863929 -11.074881 -20.678750 +6275 1682 4 0 -24.932339 -12.237137 -20.159436 +6276 1683 6 0 11.102836 18.814945 6.564463 +6277 1683 4 0 11.289797 19.730591 6.307298 +6278 1683 4 0 11.992226 18.441595 6.571960 +6279 1684 6 0 13.403000 -2.765436 13.474813 +6280 1684 4 0 13.769730 -2.059344 13.993878 +6281 1684 4 0 12.629241 -3.051764 13.938568 +6282 1685 6 0 -4.846771 12.989332 0.138872 +6283 1685 4 0 -5.140341 12.692091 -0.669471 +6284 1685 4 0 -4.237694 12.323085 0.503203 +6285 1686 6 0 -7.158804 -10.565376 -14.125410 +6286 1686 4 0 -7.106658 -9.969989 -13.387772 +6287 1686 4 0 -8.014522 -10.262139 -14.505555 +6288 1687 6 0 -27.281285 1.637807 7.500082 +6289 1687 4 0 -28.034365 1.595491 8.055974 +6290 1687 4 0 -27.473389 0.963037 6.821339 +6291 1688 6 0 -0.097834 20.799965 16.033059 +6292 1688 4 0 -0.061833 20.955427 16.971561 +6293 1688 4 0 0.211633 19.849506 15.947964 +6294 1689 6 0 -17.560941 -8.904350 -7.470152 +6295 1689 4 0 -17.692194 -9.827361 -7.296744 +6296 1689 4 0 -18.413628 -8.634527 -7.892701 +6297 1690 6 0 19.510410 -2.135779 6.750602 +6298 1690 4 0 19.129310 -2.691827 6.012246 +6299 1690 4 0 19.916248 -2.816246 7.354253 +6300 1691 6 0 -22.550074 2.726993 8.069055 +6301 1691 4 0 -22.055287 3.149406 8.816420 +6302 1691 4 0 -23.436863 2.498421 8.376578 +6303 1692 6 0 12.975725 16.091516 4.066177 +6304 1692 4 0 12.574447 15.652668 4.834328 +6305 1692 4 0 13.351330 15.347325 3.556206 +6306 1693 6 0 4.646769 -11.986650 5.429828 +6307 1693 4 0 4.999571 -11.714192 4.521067 +6308 1693 4 0 3.860805 -12.541717 5.180051 +6309 1694 6 0 -25.235875 -9.797804 -17.843826 +6310 1694 4 0 -24.333006 -9.678887 -17.478651 +6311 1694 4 0 -25.154219 -10.357082 -18.609102 +6312 1695 6 0 11.868872 -11.212949 -8.438903 +6313 1695 4 0 11.896093 -12.062241 -7.862109 +6314 1695 4 0 12.728803 -11.139741 -8.855401 +6315 1696 6 0 17.367617 -1.497743 -14.604934 +6316 1696 4 0 17.309530 -0.538237 -14.454327 +6317 1696 4 0 16.651273 -1.922704 -14.219436 +6318 1697 6 0 8.667339 4.899012 8.930629 +6319 1697 4 0 8.353473 5.408040 8.182722 +6320 1697 4 0 8.163336 5.229248 9.676915 +6321 1698 6 0 -15.429574 17.683315 9.572006 +6322 1698 4 0 -15.724205 17.604776 10.464011 +6323 1698 4 0 -15.265015 16.716829 9.310192 +6324 1699 6 0 -23.494483 -11.734522 -13.358407 +6325 1699 4 0 -22.637486 -11.515244 -13.732205 +6326 1699 4 0 -23.249990 -12.537148 -12.866248 +6327 1700 6 0 -2.321548 19.267216 -1.843679 +6328 1700 4 0 -1.979401 18.732155 -2.589027 +6329 1700 4 0 -1.922284 20.138548 -2.014462 +6330 1701 6 0 3.241639 7.816664 9.859978 +6331 1701 4 0 3.830186 8.534324 10.230363 +6332 1701 4 0 3.848530 7.292787 9.307399 +6333 1702 6 0 23.128975 -6.691964 -6.315464 +6334 1702 4 0 23.778438 -6.570891 -6.974137 +6335 1702 4 0 22.501465 -5.970161 -6.490266 +6336 1703 6 0 19.510034 14.065263 20.822119 +6337 1703 4 0 19.858660 14.498532 21.601080 +6338 1703 4 0 18.527411 14.085196 20.963708 +6339 1704 6 0 23.620502 15.862352 -17.889270 +6340 1704 4 0 23.702347 16.808368 -17.871251 +6341 1704 4 0 24.460420 15.474942 -18.227702 +6342 1705 6 0 0.280487 -11.413982 6.100970 +6343 1705 4 0 -0.020983 -11.734838 5.286550 +6344 1705 4 0 -0.533188 -11.093828 6.515383 +6345 1706 6 0 4.888182 13.212978 -12.788937 +6346 1706 4 0 4.811212 13.849406 -12.115682 +6347 1706 4 0 5.658749 13.451904 -13.292659 +6348 1707 6 0 -0.778683 -14.633842 19.192088 +6349 1707 4 0 0.068746 -14.541913 19.608269 +6350 1707 4 0 -0.746217 -14.102331 18.428497 +6351 1708 6 0 13.914707 -6.162346 9.195387 +6352 1708 4 0 13.649776 -6.881207 8.533412 +6353 1708 4 0 13.921705 -5.396594 8.630327 +6354 1709 6 0 5.918950 -10.003796 18.819888 +6355 1709 4 0 5.593681 -9.082358 18.773797 +6356 1709 4 0 6.335696 -10.082856 17.966116 +6357 1710 6 0 5.800793 -13.047074 9.485819 +6358 1710 4 0 5.149198 -12.578404 10.015587 +6359 1710 4 0 5.268076 -13.674415 8.965513 +6360 1711 6 0 -14.871416 6.062880 9.725201 +6361 1711 4 0 -14.929573 6.618371 8.917863 +6362 1711 4 0 -14.144906 5.419527 9.466087 +6363 1712 6 0 20.324875 13.466462 -0.499122 +6364 1712 4 0 21.247971 13.704707 -0.183814 +6365 1712 4 0 20.407782 13.624960 -1.484430 +6366 1713 6 0 14.435517 -20.166926 -14.557910 +6367 1713 4 0 15.392894 -20.186163 -14.367445 +6368 1713 4 0 14.408577 -20.346774 -15.497151 +6369 1714 6 0 -16.234833 1.803853 -11.857132 +6370 1714 4 0 -16.542525 1.963315 -10.988159 +6371 1714 4 0 -16.125965 2.663685 -12.253266 +6372 1715 6 0 5.603802 10.853652 14.181232 +6373 1715 4 0 4.967001 11.570744 14.103506 +6374 1715 4 0 5.112428 10.099067 14.600012 +6375 1716 6 0 -9.571538 -5.196535 -13.987191 +6376 1716 4 0 -8.921300 -5.201306 -13.287766 +6377 1716 4 0 -9.272779 -4.631556 -14.762861 +6378 1717 6 0 -0.910109 -6.872259 20.397408 +6379 1717 4 0 -1.142400 -7.798393 20.536047 +6380 1717 4 0 -1.036778 -6.702293 19.444051 +6381 1718 6 0 -12.922858 14.220990 -13.435094 +6382 1718 4 0 -13.045814 13.904342 -12.512925 +6383 1718 4 0 -11.991363 14.443415 -13.600018 +6384 1719 6 0 -20.145038 7.688023 -15.204652 +6385 1719 4 0 -19.285409 7.391425 -14.875634 +6386 1719 4 0 -20.496640 7.059764 -15.839841 +6387 1720 6 0 -5.329489 -11.195881 -18.058590 +6388 1720 4 0 -4.529646 -10.716556 -18.053482 +6389 1720 4 0 -5.175370 -11.944129 -17.502821 +6390 1721 6 0 -4.095176 7.801479 14.167088 +6391 1721 4 0 -4.165281 6.967753 13.710500 +6392 1721 4 0 -4.424466 8.518942 13.657209 +6393 1722 6 0 4.268934 -2.427400 -14.058821 +6394 1722 4 0 3.658313 -1.685938 -14.058738 +6395 1722 4 0 4.003282 -2.951965 -14.808726 +6396 1723 6 0 8.751768 -9.075907 8.222826 +6397 1723 4 0 8.238298 -9.781595 7.726938 +6398 1723 4 0 8.832788 -8.372787 7.566934 +6399 1724 6 0 -2.030633 -16.421805 9.382972 +6400 1724 4 0 -3.001825 -16.480774 9.651189 +6401 1724 4 0 -1.831960 -15.434055 9.498271 +6402 1725 6 0 -25.423917 -5.184358 19.460275 +6403 1725 4 0 -25.411355 -4.513854 18.790648 +6404 1725 4 0 -24.533549 -5.279059 19.872583 +6405 1726 6 0 -2.666399 -5.808727 -16.793146 +6406 1726 4 0 -2.024398 -6.172832 -16.200012 +6407 1726 4 0 -3.330516 -5.483909 -16.238573 +6408 1727 6 0 21.181989 15.710253 -10.722839 +6409 1727 4 0 20.653330 16.200547 -11.388544 +6410 1727 4 0 20.518018 15.224350 -10.216895 +6411 1728 6 0 10.656923 -19.476259 -2.456922 +6412 1728 4 0 10.832717 -19.488093 -3.445481 +6413 1728 4 0 10.250558 -20.351142 -2.291869 +6414 1729 6 0 25.111320 11.672906 -19.193595 +6415 1729 4 0 25.138171 11.478665 -18.282125 +6416 1729 4 0 24.182357 11.511761 -19.351363 +6417 1730 6 0 -23.200367 10.470264 2.902172 +6418 1730 4 0 -22.375402 10.749923 3.283481 +6419 1730 4 0 -23.150590 10.446395 1.924180 +6420 1731 6 0 -2.505105 -5.473938 -19.743686 +6421 1731 4 0 -1.843966 -5.849443 -20.362634 +6422 1731 4 0 -2.920619 -6.270770 -19.289080 +6423 1732 6 0 -8.780745 -1.877077 -14.922296 +6424 1732 4 0 -8.514938 -2.635843 -15.397360 +6425 1732 4 0 -9.085199 -1.200825 -15.532893 +6426 1733 6 0 24.088505 -5.188189 -2.808937 +6427 1733 4 0 23.599921 -6.002172 -2.943267 +6428 1733 4 0 23.455922 -4.686553 -2.320873 +6429 1734 6 0 22.351359 7.425470 -10.093129 +6430 1734 4 0 22.221254 8.332765 -9.845260 +6431 1734 4 0 21.646534 6.920728 -9.570168 +6432 1735 6 0 14.350169 18.359669 4.097284 +6433 1735 4 0 14.109937 17.421914 3.931070 +6434 1735 4 0 14.072554 18.536427 5.036536 +6435 1736 6 0 27.317468 -3.450042 0.124188 +6436 1736 4 0 26.939527 -2.629423 0.463932 +6437 1736 4 0 28.260772 -3.496973 0.454380 +6438 1737 6 0 18.669483 0.162292 12.223874 +6439 1737 4 0 17.730334 0.262878 12.571330 +6440 1737 4 0 18.943346 -0.589794 12.749858 +6441 1738 6 0 -5.566955 -16.930775 -16.571789 +6442 1738 4 0 -6.441648 -17.209772 -16.309110 +6443 1738 4 0 -5.639154 -16.106816 -17.074766 +6444 1739 6 0 -2.921475 20.285760 15.744633 +6445 1739 4 0 -2.016920 20.514916 15.782961 +6446 1739 4 0 -3.245126 20.259651 16.667577 +6447 1740 6 0 -5.332369 15.647169 -3.415792 +6448 1740 4 0 -5.780073 16.016536 -4.186943 +6449 1740 4 0 -5.479798 16.195769 -2.646722 +6450 1741 6 0 15.921074 -18.186514 13.419302 +6451 1741 4 0 16.506049 -18.207521 14.214727 +6452 1741 4 0 15.521744 -17.337545 13.281325 +6453 1742 6 0 14.356618 -12.746498 14.307435 +6454 1742 4 0 14.126271 -12.290732 13.456316 +6455 1742 4 0 14.125424 -12.072615 14.973510 +6456 1743 6 0 -24.563586 19.861169 16.888289 +6457 1743 4 0 -24.271423 19.518156 17.745286 +6458 1743 4 0 -25.132062 20.568890 17.055680 +6459 1744 6 0 21.313706 -20.874831 -18.789259 +6460 1744 4 0 22.217533 -20.760960 -18.415032 +6461 1744 4 0 20.727813 -20.829114 -18.018243 +6462 1745 6 0 -22.635680 0.425745 -16.655779 +6463 1745 4 0 -22.761860 0.339162 -17.612196 +6464 1745 4 0 -23.459506 0.792307 -16.373813 +6465 1746 6 0 26.144043 -9.495490 -14.387597 +6466 1746 4 0 25.579221 -8.746398 -14.601070 +6467 1746 4 0 25.873666 -10.165392 -15.002042 +6468 1747 6 0 -23.297595 -18.906211 -0.461159 +6469 1747 4 0 -22.408325 -19.188074 -0.167323 +6470 1747 4 0 -23.911286 -19.189688 0.234806 +6471 1748 6 0 -0.622548 17.838288 10.712907 +6472 1748 4 0 -1.439971 18.247686 10.442799 +6473 1748 4 0 -0.378140 17.187351 10.096413 +6474 1749 6 0 15.411072 -13.353252 8.623995 +6475 1749 4 0 14.707363 -12.901715 8.076042 +6476 1749 4 0 15.905287 -13.988830 8.076423 +6477 1750 6 0 21.923001 -19.583331 -14.240322 +6478 1750 4 0 22.075731 -18.649005 -14.150919 +6479 1750 4 0 22.015325 -19.897017 -13.337089 +6480 1751 6 0 2.935997 17.036657 8.133011 +6481 1751 4 0 3.807044 17.141662 7.698882 +6482 1751 4 0 2.908723 17.824640 8.654298 +6483 1752 6 0 -27.412013 18.278336 3.981062 +6484 1752 4 0 -28.006219 18.986550 3.874615 +6485 1752 4 0 -26.604657 18.625220 3.564949 +6486 1753 6 0 24.767119 -17.376689 8.467100 +6487 1753 4 0 25.034677 -18.274073 8.247745 +6488 1753 4 0 24.572504 -17.372764 9.407309 +6489 1754 6 0 -13.003243 -11.441578 13.780080 +6490 1754 4 0 -12.042782 -11.458495 13.652747 +6491 1754 4 0 -13.148063 -12.394708 13.704955 +6492 1755 6 0 15.688282 -7.232516 -0.339939 +6493 1755 4 0 16.449877 -6.627843 -0.361901 +6494 1755 4 0 14.991365 -6.661690 -0.041038 +6495 1756 6 0 11.147257 19.763552 -1.319428 +6496 1756 4 0 12.091516 19.826512 -1.542128 +6497 1756 4 0 10.791166 18.908813 -1.667004 +6498 1757 6 0 -7.494481 -7.378915 14.293630 +6499 1757 4 0 -8.055772 -6.598314 14.231678 +6500 1757 4 0 -7.492239 -7.996336 13.497808 +6501 1758 6 0 12.398150 -14.923360 -13.423871 +6502 1758 4 0 13.226011 -15.063936 -12.905542 +6503 1758 4 0 12.384263 -15.811229 -13.930308 +6504 1759 6 0 -27.354781 16.207013 -2.080282 +6505 1759 4 0 -27.773374 15.417476 -1.753252 +6506 1759 4 0 -26.769089 15.853853 -2.726016 +6507 1760 6 0 -21.588756 -10.691290 -14.634202 +6508 1760 4 0 -20.864974 -10.142417 -14.313329 +6509 1760 4 0 -22.092217 -10.206931 -15.343402 +6510 1761 6 0 -15.891662 -2.331448 -9.986612 +6511 1761 4 0 -16.165526 -2.271915 -10.920230 +6512 1761 4 0 -16.438270 -1.699757 -9.489314 +6513 1762 6 0 22.887456 16.566156 19.955577 +6514 1762 4 0 23.271415 15.746747 20.347130 +6515 1762 4 0 22.072508 16.181382 19.562781 +6516 1763 6 0 23.972546 -20.036642 10.589623 +6517 1763 4 0 22.980691 -20.033626 10.504814 +6518 1763 4 0 24.188289 -20.743981 11.184377 +6519 1764 6 0 -14.810897 -16.471565 2.793852 +6520 1764 4 0 -14.868506 -16.959673 3.603780 +6521 1764 4 0 -15.147942 -15.567810 2.891865 +6522 1765 6 0 15.022183 19.763656 9.414504 +6523 1765 4 0 14.727721 20.725814 9.294400 +6524 1765 4 0 14.198126 19.316744 9.803487 +6525 1766 6 0 7.167340 -17.033861 0.122492 +6526 1766 4 0 7.922624 -17.174527 -0.428152 +6527 1766 4 0 7.373246 -16.583291 0.937782 +6528 1767 6 0 -11.594968 10.896089 -10.580500 +6529 1767 4 0 -11.121081 11.033261 -11.432170 +6530 1767 4 0 -10.865005 11.002637 -9.903313 +6531 1768 6 0 13.844708 19.069913 -14.047834 +6532 1768 4 0 12.983337 18.716343 -13.811534 +6533 1768 4 0 13.787413 20.053839 -14.066463 +6534 1769 6 0 3.487281 19.589235 9.612730 +6535 1769 4 0 2.698355 20.090461 9.969632 +6536 1769 4 0 4.250101 19.910242 10.053781 +6537 1770 6 0 -3.973097 19.421213 7.719503 +6538 1770 4 0 -4.241991 20.257528 7.213642 +6539 1770 4 0 -3.132076 19.220373 7.212628 +6540 1771 6 0 -12.775076 2.609100 10.411237 +6541 1771 4 0 -11.827718 2.459042 10.644395 +6542 1771 4 0 -12.804655 2.331119 9.464699 +6543 1772 6 0 -24.197168 6.439006 -6.711367 +6544 1772 4 0 -25.160507 6.393035 -6.538446 +6545 1772 4 0 -23.942233 5.506445 -6.828627 +6546 1773 6 0 -2.117774 -4.949968 18.594717 +6547 1773 4 0 -2.924336 -5.465197 18.506055 +6548 1773 4 0 -2.296534 -4.057750 18.222583 +6549 1774 6 0 -10.788206 6.295992 1.048829 +6550 1774 4 0 -10.485607 7.066710 1.589289 +6551 1774 4 0 -10.038032 6.105261 0.487985 +6552 1775 6 0 -12.857377 -3.305264 -10.725085 +6553 1775 4 0 -13.206640 -2.923560 -11.499351 +6554 1775 4 0 -13.499606 -3.077602 -10.047332 +6555 1776 6 0 -11.268130 12.801261 9.055194 +6556 1776 4 0 -11.672865 13.689974 8.877182 +6557 1776 4 0 -11.032167 12.415049 8.150138 +6558 1777 6 0 13.406197 0.438838 6.515611 +6559 1777 4 0 12.971912 1.148987 7.055731 +6560 1777 4 0 13.378188 0.782754 5.596959 +6561 1778 6 0 16.121687 13.290724 10.280494 +6562 1778 4 0 16.894647 12.756757 10.507582 +6563 1778 4 0 15.529920 12.609242 9.885455 +6564 1779 6 0 1.591126 8.482167 4.697447 +6565 1779 4 0 1.970540 9.119397 4.113006 +6566 1779 4 0 2.267655 8.435325 5.388951 +6567 1780 6 0 -17.696505 1.721021 10.517174 +6568 1780 4 0 -17.885845 2.645526 10.594973 +6569 1780 4 0 -18.179500 1.418546 11.298333 +6570 1781 6 0 -1.148874 9.889607 17.693251 +6571 1781 4 0 -0.454725 10.039896 17.084647 +6572 1781 4 0 -1.617929 9.083378 17.328962 +6573 1782 6 0 -9.511269 -11.292655 15.803762 +6574 1782 4 0 -10.218255 -10.722353 16.196307 +6575 1782 4 0 -9.799298 -12.212118 15.932439 +6576 1783 6 0 -15.065889 16.639418 -8.067448 +6577 1783 4 0 -15.835102 17.201609 -8.362394 +6578 1783 4 0 -15.172025 15.753046 -8.516586 +6579 1784 6 0 -22.136814 -17.146244 -13.973167 +6580 1784 4 0 -21.367059 -16.850746 -13.432779 +6581 1784 4 0 -22.384487 -16.427789 -14.634859 +6582 1785 6 0 7.866282 -10.293632 -17.800934 +6583 1785 4 0 7.775951 -11.047150 -17.161148 +6584 1785 4 0 8.173086 -9.555520 -17.163954 +6585 1786 6 0 -11.457596 -0.574420 15.816493 +6586 1786 4 0 -11.795621 0.320073 15.789591 +6587 1786 4 0 -10.561019 -0.510839 15.442995 +6588 1787 6 0 20.020980 -12.359468 -8.719780 +6589 1787 4 0 20.891102 -12.503083 -8.310836 +6590 1787 4 0 19.657638 -11.746384 -8.095286 +6591 1788 6 0 -11.584374 -20.453145 18.626549 +6592 1788 4 0 -11.940173 -20.540398 19.531255 +6593 1788 4 0 -12.005638 -21.078955 18.029825 +6594 1789 6 0 3.431174 19.121516 18.407979 +6595 1789 4 0 3.226206 20.056373 18.426687 +6596 1789 4 0 2.600881 18.679871 18.370259 +6597 1790 6 0 -13.315767 -3.798762 16.329856 +6598 1790 4 0 -13.096103 -4.569637 15.670760 +6599 1790 4 0 -12.649730 -3.801668 17.013121 +6600 1791 6 0 7.563392 -5.518546 10.504795 +6601 1791 4 0 6.706770 -5.750354 10.096728 +6602 1791 4 0 7.922512 -6.417021 10.555834 +6603 1792 6 0 -18.725820 19.110329 -7.091283 +6604 1792 4 0 -19.518142 19.318716 -7.662306 +6605 1792 4 0 -18.568680 19.881279 -6.590714 +6606 1793 6 0 -1.414023 -16.961715 12.639857 +6607 1793 4 0 -1.328118 -15.968577 12.668980 +6608 1793 4 0 -1.076983 -17.347672 11.778245 +6609 1794 6 0 -23.307644 10.461811 -20.820802 +6610 1794 4 0 -23.561946 9.673912 -20.318452 +6611 1794 4 0 -24.099105 10.583838 -21.379713 +6612 1795 6 0 18.109258 -13.123924 17.182346 +6613 1795 4 0 19.074027 -13.199454 16.973877 +6614 1795 4 0 17.765173 -12.302968 16.728002 +6615 1796 6 0 21.683386 18.223931 -5.030005 +6616 1796 4 0 22.567099 18.027021 -5.437892 +6617 1796 4 0 21.636745 17.754335 -4.163593 +6618 1797 6 0 25.055072 19.034839 -7.681292 +6619 1797 4 0 24.766294 18.344263 -7.038060 +6620 1797 4 0 25.882695 18.757787 -7.948244 +6621 1798 6 0 15.570913 13.019010 5.553904 +6622 1798 4 0 15.992685 13.329314 6.362922 +6623 1798 4 0 15.449140 12.068146 5.738277 +6624 1799 6 0 -0.520016 -0.269780 14.795928 +6625 1799 4 0 -0.180326 -0.456884 15.694661 +6626 1799 4 0 -1.219092 -0.915185 14.727056 +6627 1800 6 0 1.663902 -15.429144 -10.527250 +6628 1800 4 0 2.554915 -15.533567 -10.136462 +6629 1800 4 0 1.815948 -15.297258 -11.416174 +6630 1801 6 0 -22.648336 -4.623238 -12.225694 +6631 1801 4 0 -23.412412 -4.010770 -12.025660 +6632 1801 4 0 -21.872894 -4.224451 -11.815463 +6633 1802 6 0 -2.279585 -20.867759 -19.023308 +6634 1802 4 0 -3.100549 -20.369345 -19.314139 +6635 1802 4 0 -1.811469 -21.235753 -19.767859 +6636 1803 6 0 -22.243475 -13.329179 -1.390694 +6637 1803 4 0 -22.862810 -12.659332 -1.686427 +6638 1803 4 0 -22.410657 -13.599367 -0.469217 +6639 1804 6 0 23.607826 -9.844602 16.352810 +6640 1804 4 0 24.370141 -9.837102 16.979270 +6641 1804 4 0 22.885616 -9.527980 16.925581 +6642 1805 6 0 -17.460421 9.171816 -11.938616 +6643 1805 4 0 -18.218389 8.865436 -11.398928 +6644 1805 4 0 -17.867876 9.968898 -12.335632 +6645 1806 6 0 2.263863 -17.526491 14.554618 +6646 1806 4 0 1.859635 -17.896680 15.358713 +6647 1806 4 0 2.052535 -18.087323 13.764230 +6648 1807 6 0 27.368617 -13.116454 -17.139830 +6649 1807 4 0 27.233784 -13.465846 -16.264251 +6650 1807 4 0 27.362385 -13.865254 -17.806940 +6651 1808 6 0 16.784972 2.549591 14.309398 +6652 1808 4 0 17.733190 2.537919 14.322805 +6653 1808 4 0 16.413277 1.810095 13.861707 +6654 1809 6 0 21.804761 -2.107242 -5.095741 +6655 1809 4 0 22.776789 -2.281899 -4.959560 +6656 1809 4 0 21.413198 -2.898127 -5.388708 +6657 1810 6 0 14.063924 6.483674 -0.351431 +6658 1810 4 0 14.941176 6.100507 -0.517796 +6659 1810 4 0 14.071859 7.050391 0.399753 +6660 1811 6 0 14.554835 16.507491 9.329558 +6661 1811 4 0 15.358643 16.591416 9.875030 +6662 1811 4 0 13.889851 17.088326 9.657109 +6663 1812 6 0 8.670655 -18.428515 -11.354395 +6664 1812 4 0 9.496711 -18.254251 -11.776580 +6665 1812 4 0 8.693110 -18.508570 -10.379319 +6666 1813 6 0 -17.333287 2.077059 19.999340 +6667 1813 4 0 -18.012974 2.265838 19.359237 +6668 1813 4 0 -17.678958 2.658724 20.686523 +6669 1814 6 0 -12.269943 7.557325 8.022561 +6670 1814 4 0 -11.782231 7.901385 7.310410 +6671 1814 4 0 -11.518722 7.369844 8.741429 +6672 1815 6 0 -16.422160 -12.244301 6.857276 +6673 1815 4 0 -16.476236 -12.690789 7.708566 +6674 1815 4 0 -17.265810 -12.438972 6.474023 +6675 1816 6 0 -12.460293 15.701651 -2.123616 +6676 1816 4 0 -12.202263 16.633440 -2.262429 +6677 1816 4 0 -12.915395 15.335750 -2.913659 +6678 1817 6 0 19.857137 7.435921 -19.855513 +6679 1817 4 0 19.224411 8.121790 -20.149860 +6680 1817 4 0 19.459580 7.115365 -18.985221 +6681 1818 6 0 27.414938 3.220691 12.551587 +6682 1818 4 0 28.302084 3.292286 12.082110 +6683 1818 4 0 27.376652 2.288121 12.758098 +6684 1819 6 0 -20.578446 6.501862 -7.543872 +6685 1819 4 0 -21.322455 7.133983 -7.483478 +6686 1819 4 0 -20.905164 5.709027 -7.068017 +6687 1820 6 0 9.893421 -13.954239 -2.145744 +6688 1820 4 0 10.845577 -13.887452 -1.806008 +6689 1820 4 0 9.670044 -13.100245 -2.522670 +6690 1821 6 0 -4.428072 -19.794959 6.392084 +6691 1821 4 0 -3.499634 -19.499125 6.457248 +6692 1821 4 0 -4.796122 -19.302160 7.159538 +6693 1822 6 0 -7.874919 11.488098 -11.872687 +6694 1822 4 0 -7.741906 10.850602 -11.130468 +6695 1822 4 0 -8.663122 11.156415 -12.262641 +6696 1823 6 0 25.941607 -13.435898 9.799183 +6697 1823 4 0 26.834803 -13.623931 10.154795 +6698 1823 4 0 25.332757 -14.073159 10.291155 +6699 1824 6 0 -19.551589 -5.315854 19.441555 +6700 1824 4 0 -19.573638 -5.247652 20.432003 +6701 1824 4 0 -18.874142 -4.641904 19.223175 +6702 1825 6 0 -15.895156 17.865430 12.295752 +6703 1825 4 0 -15.942604 18.800693 12.596548 +6704 1825 4 0 -16.548061 17.362585 12.771509 +6705 1826 6 0 2.671083 -14.766415 2.401009 +6706 1826 4 0 1.987603 -14.345575 1.847880 +6707 1826 4 0 2.531547 -14.517967 3.328895 +6708 1827 6 0 12.335851 -9.704468 -20.394740 +6709 1827 4 0 12.648806 -9.830295 -19.492670 +6710 1827 4 0 11.490958 -10.100623 -20.194535 +6711 1828 6 0 -22.106737 -9.538400 8.455985 +6712 1828 4 0 -21.536209 -9.084366 9.058590 +6713 1828 4 0 -23.017732 -9.207212 8.501551 +6714 1829 6 0 12.648535 6.444583 -9.932281 +6715 1829 4 0 13.157813 6.358331 -10.726454 +6716 1829 4 0 11.747411 6.253342 -10.180418 +6717 1830 6 0 -13.625525 -14.166725 14.041460 +6718 1830 4 0 -13.177614 -14.592522 13.259629 +6719 1830 4 0 -14.592492 -14.334369 13.940732 +6720 1831 6 0 6.601614 16.498956 -16.461129 +6721 1831 4 0 7.358480 15.895066 -16.451685 +6722 1831 4 0 6.023786 16.041896 -17.084703 +6723 1832 6 0 21.778571 -2.612574 13.360688 +6724 1832 4 0 22.384822 -2.519802 12.682789 +6725 1832 4 0 21.622799 -1.672884 13.624001 +6726 1833 6 0 -20.149213 6.013192 6.945622 +6727 1833 4 0 -21.145473 5.909263 6.918876 +6728 1833 4 0 -19.835482 6.282517 6.065703 +6729 1834 6 0 -21.966774 -11.494919 -8.738743 +6730 1834 4 0 -22.851768 -11.211695 -9.113733 +6731 1834 4 0 -21.879165 -10.921961 -8.012191 +6732 1835 6 0 15.449095 -9.497086 12.201305 +6733 1835 4 0 16.382306 -9.836986 12.244632 +6734 1835 4 0 15.422419 -9.084200 11.356115 +6735 1836 6 0 12.664756 -15.306651 -20.531836 +6736 1836 4 0 12.034408 -16.012414 -20.359938 +6737 1836 4 0 12.739209 -14.577278 -19.974973 +6738 1837 6 0 -7.972869 -5.604918 -11.934405 +6739 1837 4 0 -7.601267 -4.885318 -11.379446 +6740 1837 4 0 -8.575310 -6.063681 -11.263704 +6741 1838 6 0 0.299553 12.700530 -18.524181 +6742 1838 4 0 0.558430 11.815355 -18.777046 +6743 1838 4 0 -0.711668 12.618485 -18.481012 +6744 1839 6 0 -0.824908 18.918494 -20.332651 +6745 1839 4 0 0.055729 18.800950 -20.088514 +6746 1839 4 0 -0.726815 18.736133 -21.275575 +6747 1840 6 0 25.716218 -17.621624 -18.165089 +6748 1840 4 0 25.183585 -18.348327 -18.615572 +6749 1840 4 0 26.570805 -18.051277 -17.821631 +6750 1841 6 0 11.895246 -12.886376 -15.030415 +6751 1841 4 0 12.581969 -12.241572 -14.789572 +6752 1841 4 0 12.014494 -13.590976 -14.363464 +6753 1842 6 0 -6.984781 -6.050242 10.699580 +6754 1842 4 0 -6.200372 -6.230567 10.144341 +6755 1842 4 0 -6.715278 -5.563587 11.454374 +6756 1843 6 0 -7.335609 -12.055455 -4.954546 +6757 1843 4 0 -6.870389 -12.537029 -5.731051 +6758 1843 4 0 -8.034369 -11.614893 -5.410536 +6759 1844 6 0 7.328653 12.351276 10.622525 +6760 1844 4 0 7.205722 12.826673 9.764783 +6761 1844 4 0 6.491360 12.585679 11.094427 +6762 1845 6 0 -2.064418 15.964062 4.897369 +6763 1845 4 0 -1.989044 16.110456 3.944429 +6764 1845 4 0 -1.188158 16.010465 5.256453 +6765 1846 6 0 10.673140 16.947190 -7.298199 +6766 1846 4 0 11.053321 16.848368 -6.437645 +6767 1846 4 0 9.833705 16.415071 -7.530378 +6768 1847 6 0 25.146955 -10.850377 -5.894794 +6769 1847 4 0 25.793466 -10.144367 -5.792885 +6770 1847 4 0 25.341761 -11.315139 -6.748470 +6771 1848 6 0 -20.898709 -20.024244 -0.432532 +6772 1848 4 0 -21.327485 -20.809324 -0.731327 +6773 1848 4 0 -20.384646 -19.736744 -1.159428 +6774 1849 6 0 15.773125 -11.828239 1.267979 +6775 1849 4 0 15.082308 -11.485912 1.791000 +6776 1849 4 0 16.210809 -11.047975 0.843250 +6777 1850 6 0 -25.459831 -14.049130 16.602221 +6778 1850 4 0 -25.659268 -15.033606 16.753032 +6779 1850 4 0 -26.167299 -13.609133 17.155971 +6780 1851 6 0 -15.346212 9.776118 0.552706 +6781 1851 4 0 -14.861031 10.583944 0.897097 +6782 1851 4 0 -15.499398 9.230659 1.360288 +6783 1852 6 0 1.515239 -10.027493 16.408903 +6784 1852 4 0 2.112245 -9.685145 15.772127 +6785 1852 4 0 1.563862 -10.961534 16.268707 +6786 1853 6 0 8.730778 -2.046469 -16.855487 +6787 1853 4 0 8.003213 -2.349766 -16.293070 +6788 1853 4 0 8.893912 -1.127143 -16.700440 +6789 1854 6 0 -12.659858 10.277753 9.764551 +6790 1854 4 0 -12.954976 10.194740 10.671493 +6791 1854 4 0 -12.294313 11.185370 9.686563 +6792 1855 6 0 13.241019 7.614156 1.958471 +6793 1855 4 0 13.989186 7.821908 2.548064 +6794 1855 4 0 12.569506 7.225025 2.564990 +6795 1856 6 0 18.743445 -1.851686 14.221199 +6796 1856 4 0 19.241705 -2.155912 15.013052 +6797 1856 4 0 17.934973 -2.360999 14.283218 +6798 1857 6 0 20.097738 14.045420 -3.353931 +6799 1857 4 0 20.264111 13.632005 -4.240012 +6800 1857 4 0 19.782670 14.876950 -3.580329 +6801 1858 6 0 22.656523 -13.025771 -7.851202 +6802 1858 4 0 23.058494 -13.682024 -8.427211 +6803 1858 4 0 22.939496 -13.206983 -6.927788 +6804 1859 6 0 22.687429 4.701978 5.232797 +6805 1859 4 0 22.127391 3.970799 5.568822 +6806 1859 4 0 22.543397 5.316387 5.948219 +6807 1860 6 0 23.649228 -7.915795 -3.510236 +6808 1860 4 0 22.801078 -8.238516 -3.339971 +6809 1860 4 0 23.474938 -7.503073 -4.391727 +6810 1861 6 0 -6.616017 -20.555130 17.274390 +6811 1861 4 0 -6.785872 -19.593361 17.044755 +6812 1861 4 0 -6.639098 -20.935653 16.386762 +6813 1862 6 0 11.575769 10.993842 8.632733 +6814 1862 4 0 11.631285 10.248287 9.251562 +6815 1862 4 0 11.054687 11.776369 9.032913 +6816 1863 6 0 -14.897591 -13.741408 -8.424343 +6817 1863 4 0 -13.944044 -13.521919 -8.374624 +6818 1863 4 0 -15.245652 -13.416716 -9.247098 +6819 1864 6 0 -7.606286 -16.239672 5.296165 +6820 1864 4 0 -8.529013 -16.377754 5.125689 +6821 1864 4 0 -7.372109 -15.298609 5.089587 +6822 1865 6 0 21.651688 -6.687757 -17.914010 +6823 1865 4 0 21.631109 -7.371723 -17.250699 +6824 1865 4 0 22.595382 -6.421930 -17.913376 +6825 1866 6 0 8.244086 -0.418132 8.413538 +6826 1866 4 0 8.150004 -1.042562 7.678730 +6827 1866 4 0 7.835426 -0.797019 9.189825 +6828 1867 6 0 16.479760 -10.801798 -19.696932 +6829 1867 4 0 17.075192 -11.093875 -20.402321 +6830 1867 4 0 17.056365 -10.719762 -18.940382 +6831 1868 6 0 -0.277774 0.459271 -13.592265 +6832 1868 4 0 0.641958 0.154550 -13.512461 +6833 1868 4 0 -0.452113 1.346343 -13.286369 +6834 1869 6 0 -6.542284 15.376168 4.177517 +6835 1869 4 0 -5.816160 15.112821 4.810192 +6836 1869 4 0 -6.899831 14.592226 3.628797 +6837 1870 6 0 -20.635866 7.001713 -1.480479 +6838 1870 4 0 -21.373222 6.994284 -2.078088 +6839 1870 4 0 -20.006067 6.359671 -1.951231 +6840 1871 6 0 -13.639335 3.376760 17.002766 +6841 1871 4 0 -13.969979 2.665180 17.593575 +6842 1871 4 0 -13.046017 3.905659 17.530455 +6843 1872 6 0 -6.547337 20.684985 14.541933 +6844 1872 4 0 -6.972273 21.348698 14.071679 +6845 1872 4 0 -5.602331 20.918763 14.522709 +6846 1873 6 0 -2.497800 -13.782262 -4.791828 +6847 1873 4 0 -1.576617 -13.507624 -4.869174 +6848 1873 4 0 -2.714797 -14.013702 -5.709334 +6849 1874 6 0 -1.112625 18.563757 18.790030 +6850 1874 4 0 -0.288236 18.142534 18.527379 +6851 1874 4 0 -0.946536 19.452779 18.744542 +6852 1875 6 0 -13.988854 -2.769276 -13.122084 +6853 1875 4 0 -13.598926 -2.700606 -13.943868 +6854 1875 4 0 -14.937873 -2.607884 -13.208114 +6855 1876 6 0 -16.715661 8.750744 -17.681497 +6856 1876 4 0 -15.798116 8.603619 -18.047851 +6857 1876 4 0 -16.635460 9.420085 -17.000771 +6858 1877 6 0 2.991113 -12.748536 9.631899 +6859 1877 4 0 2.533802 -13.278079 8.996870 +6860 1877 4 0 2.583180 -11.923543 9.637997 +6861 1878 6 0 -27.414426 -12.634511 18.337817 +6862 1878 4 0 -28.225666 -12.744824 17.838871 +6863 1878 4 0 -27.706128 -12.906300 19.286418 +6864 1879 6 0 11.850131 -20.736745 10.117226 +6865 1879 4 0 12.209918 -19.885422 9.990598 +6866 1879 4 0 12.449458 -21.164159 10.776006 +6867 1880 6 0 16.900404 -9.611117 0.299881 +6868 1880 4 0 17.702920 -9.200486 0.626455 +6869 1880 4 0 16.211832 -8.949525 0.285394 +6870 1881 6 0 1.300636 17.476583 -19.357702 +6871 1881 4 0 1.244601 16.535623 -19.680589 +6872 1881 4 0 2.229065 17.802299 -19.528512 +6873 1882 6 0 -13.442641 6.855380 -12.602329 +6874 1882 4 0 -13.248683 5.960155 -12.345808 +6875 1882 4 0 -12.964930 7.379163 -11.927446 +6876 1883 6 0 10.508692 10.781998 13.857653 +6877 1883 4 0 10.700750 11.227397 13.025331 +6878 1883 4 0 11.274159 10.169036 14.047871 +6879 1884 6 0 -15.161111 15.497808 -1.075417 +6880 1884 4 0 -14.941306 16.067302 -1.834212 +6881 1884 4 0 -14.307102 15.425376 -0.587763 +6882 1885 6 0 26.516448 19.605204 -1.401155 +6883 1885 4 0 27.409955 19.971686 -1.420282 +6884 1885 4 0 26.420947 18.971191 -0.667802 +6885 1886 6 0 -0.954004 8.187819 13.771505 +6886 1886 4 0 -0.458409 7.469182 14.137804 +6887 1886 4 0 -1.797548 7.882182 13.530929 +6888 1887 6 0 15.694940 -16.566561 10.671838 +6889 1887 4 0 15.180482 -16.576742 9.844033 +6890 1887 4 0 14.966563 -16.548505 11.318780 +6891 1888 6 0 18.598747 3.441754 -19.980603 +6892 1888 4 0 19.607131 3.445422 -19.714075 +6893 1888 4 0 18.629619 3.587760 -20.937873 +6894 1889 6 0 -4.101725 20.626483 18.518698 +6895 1889 4 0 -4.832741 21.173287 18.195756 +6896 1889 4 0 -3.506641 21.284151 19.004490 +6897 1890 6 0 -1.622747 20.903759 -10.623135 +6898 1890 4 0 -1.749055 20.907257 -9.665824 +6899 1890 4 0 -2.518273 20.806241 -11.004696 +6900 1891 6 0 -2.179807 -14.291095 -12.926864 +6901 1891 4 0 -2.705153 -14.473812 -12.111290 +6902 1891 4 0 -1.495280 -13.773858 -12.562680 +6903 1892 6 0 -21.678830 15.695505 11.326422 +6904 1892 4 0 -21.490132 16.123832 12.219822 +6905 1892 4 0 -22.555374 16.000330 11.105890 +6906 1893 6 0 20.387528 -15.104299 -14.428654 +6907 1893 4 0 19.639614 -14.550582 -14.652181 +6908 1893 4 0 20.966724 -14.615439 -13.782083 +6909 1894 6 0 8.543989 2.061633 14.171285 +6910 1894 4 0 8.138366 1.205164 14.195988 +6911 1894 4 0 8.018048 2.600851 14.790181 +6912 1895 6 0 -14.889828 7.565748 -1.232224 +6913 1895 4 0 -15.277980 8.149588 -0.532147 +6914 1895 4 0 -14.157076 7.163538 -0.720742 +6915 1896 6 0 6.890439 6.835565 10.786892 +6916 1896 4 0 7.316224 7.702174 10.597929 +6917 1896 4 0 7.041785 6.699181 11.734956 +6918 1897 6 0 -23.725715 6.589830 20.135978 +6919 1897 4 0 -24.326282 5.920341 20.500508 +6920 1897 4 0 -24.274788 7.300563 19.971121 +6921 1898 6 0 -0.448883 -20.864583 -14.617458 +6922 1898 4 0 0.071192 -21.697111 -14.370110 +6923 1898 4 0 -0.336801 -20.602783 -15.491876 +6924 1899 6 0 4.752131 -18.759171 16.224472 +6925 1899 4 0 4.247100 -17.909089 16.159151 +6926 1899 4 0 5.497199 -18.596379 16.767517 +6927 1900 6 0 25.551466 11.024091 14.835821 +6928 1900 4 0 26.097565 10.360826 15.318240 +6929 1900 4 0 25.868265 11.894670 15.113284 +6930 1901 6 0 -13.792632 -0.131648 -11.968031 +6931 1901 4 0 -14.069742 -1.037349 -12.273373 +6932 1901 4 0 -14.587746 0.465719 -12.016945 +6933 1902 6 0 -2.710690 15.293627 -0.278680 +6934 1902 4 0 -2.998969 15.960057 0.331443 +6935 1902 4 0 -3.386842 14.623069 -0.355634 +6936 1903 6 0 -17.248233 -20.121844 -4.059452 +6937 1903 4 0 -17.172414 -21.044463 -4.251654 +6938 1903 4 0 -16.877225 -20.034684 -3.174803 +6939 1904 6 0 23.843575 9.736974 -14.350198 +6940 1904 4 0 23.682322 8.979239 -15.046519 +6941 1904 4 0 23.367386 9.481782 -13.520758 +6942 1905 6 0 -11.977920 -13.866924 -9.096345 +6943 1905 4 0 -12.034457 -14.762049 -8.738542 +6944 1905 4 0 -11.033924 -13.842490 -9.319192 +6945 1906 6 0 -20.844885 -20.673768 11.904219 +6946 1906 4 0 -21.211544 -21.565612 12.158518 +6947 1906 4 0 -21.251746 -20.526654 11.038182 +6948 1907 6 0 10.501648 -10.083276 10.087293 +6949 1907 4 0 10.918566 -9.250606 10.394612 +6950 1907 4 0 9.992333 -9.906650 9.274003 +6951 1908 6 0 -19.115579 -4.779064 -19.789173 +6952 1908 4 0 -18.214269 -4.399767 -19.923178 +6953 1908 4 0 -19.400662 -4.666966 -18.902157 +6954 1909 6 0 27.292959 4.591920 -14.450094 +6955 1909 4 0 27.857326 4.638750 -13.673258 +6956 1909 4 0 26.302663 4.467257 -14.132617 +6957 1910 6 0 -15.973482 -19.623868 10.652463 +6958 1910 4 0 -15.396164 -19.929927 9.974366 +6959 1910 4 0 -16.843194 -19.544182 10.235192 +6960 1911 6 0 -24.224954 -2.728737 10.935846 +6961 1911 4 0 -23.262685 -2.710705 11.036848 +6962 1911 4 0 -24.594330 -3.621981 10.847310 +6963 1912 6 0 -10.392772 -14.962488 2.206954 +6964 1912 4 0 -10.142273 -15.819733 2.617268 +6965 1912 4 0 -9.689412 -14.869628 1.550246 +6966 1913 6 0 23.781651 14.549010 -15.425504 +6967 1913 4 0 23.508500 15.178591 -16.172525 +6968 1913 4 0 23.231402 13.779403 -15.566088 +6969 1914 6 0 -16.655122 13.378532 -2.256893 +6970 1914 4 0 -15.876557 13.842392 -1.809556 +6971 1914 4 0 -17.352965 14.010234 -2.115536 +6972 1915 6 0 17.907598 17.234287 -12.510154 +6973 1915 4 0 17.700495 16.802779 -13.342124 +6974 1915 4 0 17.297348 17.961204 -12.489351 +6975 1916 6 0 17.427023 -12.078823 9.916700 +6976 1916 4 0 16.525879 -12.070244 9.636554 +6977 1916 4 0 17.909679 -12.239509 9.119337 +6978 1917 6 0 -19.359847 6.057050 19.624868 +6979 1917 4 0 -19.814369 5.574360 18.904014 +6980 1917 4 0 -19.255770 6.911903 19.182635 +6981 1918 6 0 18.674024 -19.624270 17.522963 +6982 1918 4 0 17.740156 -19.461855 17.682137 +6983 1918 4 0 18.867385 -19.535332 16.599150 +6984 1919 6 0 20.025827 3.814045 -9.622919 +6985 1919 4 0 19.683972 4.038069 -10.485997 +6986 1919 4 0 20.937506 3.543209 -9.811005 +6987 1920 6 0 5.470940 6.984171 8.109869 +6988 1920 4 0 5.850717 7.846581 8.087996 +6989 1920 4 0 5.945843 6.559192 8.827716 +6990 1921 6 0 -10.808039 20.531242 -16.312076 +6991 1921 4 0 -10.302470 21.104206 -15.760708 +6992 1921 4 0 -10.017446 20.227222 -16.784699 +6993 1922 6 0 -11.027875 -4.920821 17.870938 +6994 1922 4 0 -10.325336 -4.445713 17.369166 +6995 1922 4 0 -11.377886 -5.529192 17.224974 +6996 1923 6 0 -20.371671 10.114815 16.255481 +6997 1923 4 0 -20.580138 10.101355 15.263993 +6998 1923 4 0 -20.344545 11.071578 16.437819 +6999 1924 6 0 23.653520 3.436168 1.325510 +7000 1924 4 0 23.536106 2.474980 1.098717 +7001 1924 4 0 23.860683 3.796523 0.414552 +7002 1925 6 0 -21.567514 -2.949387 5.091162 +7003 1925 4 0 -22.071317 -3.738968 4.916553 +7004 1925 4 0 -22.336939 -2.390166 5.390630 +7005 1926 6 0 22.554166 -9.402044 -6.100872 +7006 1926 4 0 23.431323 -9.766839 -6.077907 +7007 1926 4 0 22.697180 -8.479613 -6.418284 +7008 1927 6 0 -22.569113 -4.640399 13.826281 +7009 1927 4 0 -23.358557 -5.049193 13.550678 +7010 1927 4 0 -22.257880 -5.191735 14.515317 +7011 1928 6 0 -2.385157 12.751460 -2.313524 +7012 1928 4 0 -1.730031 13.357140 -2.644514 +7013 1928 4 0 -1.978595 12.282671 -1.585523 +7014 1929 6 0 -26.161645 14.565358 1.232440 +7015 1929 4 0 -26.706603 13.814255 1.347347 +7016 1929 4 0 -26.622850 15.329972 1.567273 +7017 1930 6 0 1.453589 -9.489501 -18.511074 +7018 1930 4 0 1.470127 -10.349425 -18.991155 +7019 1930 4 0 1.973543 -8.965754 -19.091787 +7020 1931 6 0 -0.660378 -18.577536 -12.938447 +7021 1931 4 0 -0.732583 -19.053338 -12.113581 +7022 1931 4 0 -0.517701 -19.272917 -13.578982 +7023 1932 6 0 14.312654 12.150861 -6.246651 +7024 1932 4 0 14.287806 12.704737 -5.491569 +7025 1932 4 0 15.175580 11.801455 -6.299294 +7026 1933 6 0 18.998590 6.532260 -0.632888 +7027 1933 4 0 18.366049 5.787028 -0.799484 +7028 1933 4 0 19.311853 6.485139 0.272589 +7029 1934 6 0 5.329915 17.883588 20.342830 +7030 1934 4 0 4.796701 18.410992 19.709020 +7031 1934 4 0 4.770971 17.852635 21.154570 +7032 1935 6 0 24.723592 -6.944303 -11.741165 +7033 1935 4 0 24.780327 -6.008688 -11.867155 +7034 1935 4 0 24.690407 -7.329055 -12.639425 +7035 1936 6 0 -23.122003 4.618796 18.181339 +7036 1936 4 0 -23.209287 5.265752 18.869409 +7037 1936 4 0 -23.988906 4.549652 17.803581 +7038 1937 6 0 8.709146 17.478249 5.929770 +7039 1937 4 0 7.992855 18.166454 5.872705 +7040 1937 4 0 9.532770 18.014027 5.879190 +7041 1938 6 0 -25.145193 10.967387 14.467030 +7042 1938 4 0 -25.638192 11.462461 13.811080 +7043 1938 4 0 -25.115880 11.602045 15.194844 +7044 1939 6 0 -6.270672 10.298692 -9.326284 +7045 1939 4 0 -6.326041 9.841909 -8.460997 +7046 1939 4 0 -5.298295 10.155581 -9.629880 +7047 1940 6 0 8.331282 15.667208 -4.044961 +7048 1940 4 0 8.081425 16.068754 -3.248975 +7049 1940 4 0 7.784433 16.176579 -4.661216 +7050 1941 6 0 -4.605111 3.075866 17.330627 +7051 1941 4 0 -4.999875 2.960715 16.481841 +7052 1941 4 0 -5.159040 3.212840 18.083160 +7053 1942 6 0 14.687017 -3.513814 10.903431 +7054 1942 4 0 14.499277 -3.337699 11.823116 +7055 1942 4 0 14.262838 -4.331541 10.602044 +7056 1943 6 0 -20.872612 6.379762 10.816794 +7057 1943 4 0 -20.860809 7.234769 10.341581 +7058 1943 4 0 -20.061300 6.341520 11.384808 +7059 1944 6 0 7.161896 -4.360755 17.634105 +7060 1944 4 0 8.175987 -4.400233 17.464973 +7061 1944 4 0 7.057446 -4.853463 18.480499 +7062 1945 6 0 -3.475038 11.316770 16.798166 +7063 1945 4 0 -2.755042 10.845936 17.155120 +7064 1945 4 0 -3.489190 11.054731 15.856176 +7065 1946 6 0 15.663266 8.649743 3.198716 +7066 1946 4 0 15.359027 9.298705 3.810376 +7067 1946 4 0 16.192400 8.008866 3.672568 +7068 1947 6 0 5.436707 -20.461241 11.921265 +7069 1947 4 0 5.119701 -19.606856 11.530637 +7070 1947 4 0 4.713208 -20.630626 12.549382 +7071 1948 6 0 -4.801212 -17.868960 -3.936676 +7072 1948 4 0 -5.438715 -17.659702 -4.657529 +7073 1948 4 0 -4.229156 -18.589597 -4.194370 +7074 1949 6 0 -15.253442 11.238290 -10.212163 +7075 1949 4 0 -14.642285 11.918974 -10.588009 +7076 1949 4 0 -16.099309 11.643007 -10.393989 +7077 1950 6 0 26.686176 10.830985 20.584564 +7078 1950 4 0 26.369951 11.360874 21.358365 +7079 1950 4 0 26.509688 9.944710 20.906243 +7080 1951 6 0 12.561683 17.569279 18.161912 +7081 1951 4 0 12.373224 16.635553 17.927044 +7082 1951 4 0 11.953579 17.940076 18.749558 +7083 1952 6 0 -7.212093 -10.307008 17.334494 +7084 1952 4 0 -6.512620 -10.511909 17.944932 +7085 1952 4 0 -7.614860 -11.144180 17.014381 +7086 1953 6 0 1.066613 3.381658 18.538737 +7087 1953 4 0 1.472142 3.810443 19.302366 +7088 1953 4 0 0.121217 3.213227 18.686468 +7089 1954 6 0 26.591569 20.388220 15.314096 +7090 1954 4 0 27.027629 19.549241 15.003737 +7091 1954 4 0 25.677162 20.106742 15.492223 +7092 1955 6 0 -12.980829 3.037173 -5.149300 +7093 1955 4 0 -13.518049 2.271141 -5.381098 +7094 1955 4 0 -13.015144 3.271986 -4.233059 +7095 1956 6 0 -15.670290 -19.461795 -8.693893 +7096 1956 4 0 -15.312346 -19.371467 -7.762922 +7097 1956 4 0 -15.700912 -18.579237 -9.112271 +7098 1957 6 0 18.498310 -6.951013 11.923309 +7099 1957 4 0 19.331146 -6.980278 12.293062 +7100 1957 4 0 17.952458 -6.708175 12.679535 +7101 1958 6 0 22.848965 14.115566 0.206953 +7102 1958 4 0 23.127347 14.768732 -0.415947 +7103 1958 4 0 23.434401 14.218348 0.991573 +7104 1959 6 0 -23.977260 16.643521 -8.138268 +7105 1959 4 0 -24.563932 16.858836 -8.896849 +7106 1959 4 0 -23.095154 16.760370 -8.386216 +7107 1960 6 0 -26.584391 -6.397854 5.547650 +7108 1960 4 0 -25.925294 -7.061435 5.741608 +7109 1960 4 0 -26.133892 -5.544387 5.442967 +7110 1961 6 0 2.060216 -10.468459 10.640375 +7111 1961 4 0 2.489904 -9.711105 10.219505 +7112 1961 4 0 1.131111 -10.283322 10.616360 +7113 1962 6 0 5.954667 9.758583 -20.555530 +7114 1962 4 0 6.264304 10.543474 -21.120622 +7115 1962 4 0 5.484413 9.147185 -21.197897 +7116 1963 6 0 24.786566 -15.292270 2.666103 +7117 1963 4 0 23.947578 -15.213745 2.181575 +7118 1963 4 0 24.621364 -16.114647 3.180504 +7119 1964 6 0 -9.238549 4.246640 18.608373 +7120 1964 4 0 -8.516205 4.915950 18.512268 +7121 1964 4 0 -8.905672 3.343488 18.421048 +7122 1965 6 0 4.458783 0.783326 15.910622 +7123 1965 4 0 4.333357 -0.156607 15.829450 +7124 1965 4 0 5.377583 0.813141 16.228468 +7125 1966 6 0 2.440654 19.498822 -16.520052 +7126 1966 4 0 1.894281 18.987314 -15.882707 +7127 1966 4 0 2.550447 18.871750 -17.222238 +7128 1967 6 0 -14.387304 8.489545 5.108260 +7129 1967 4 0 -14.330824 9.314254 5.570879 +7130 1967 4 0 -13.611936 7.964241 5.306370 +7131 1968 6 0 -5.680779 -19.561928 -0.391390 +7132 1968 4 0 -6.492940 -19.118143 -0.731363 +7133 1968 4 0 -5.761503 -20.446667 -0.611520 +7134 1969 6 0 0.364483 -0.976730 20.596640 +7135 1969 4 0 0.190818 -1.943299 20.568078 +7136 1969 4 0 -0.296384 -0.570410 19.967598 +7137 1970 6 0 -20.103572 15.327950 -3.864750 +7138 1970 4 0 -20.721760 16.087200 -3.977948 +7139 1970 4 0 -19.620299 15.411599 -4.730333 +7140 1971 6 0 7.762229 -15.911349 -12.044815 +7141 1971 4 0 8.618390 -15.446157 -11.951239 +7142 1971 4 0 8.056718 -16.844883 -11.932849 +7143 1972 6 0 -14.271772 -19.114636 20.444087 +7144 1972 4 0 -13.631359 -18.451185 20.013255 +7145 1972 4 0 -14.788312 -18.613074 21.058254 +7146 1973 6 0 -17.296785 -16.270141 -5.846230 +7147 1973 4 0 -16.661324 -16.986407 -5.791657 +7148 1973 4 0 -17.698563 -16.270611 -6.699261 +7149 1974 6 0 5.461014 -17.908610 10.258639 +7150 1974 4 0 6.041339 -18.066045 9.495427 +7151 1974 4 0 5.907462 -17.113295 10.672048 +7152 1975 6 0 -6.579640 -20.864919 -3.728078 +7153 1975 4 0 -6.197014 -21.129682 -2.892954 +7154 1975 4 0 -5.867159 -20.529771 -4.364102 +7155 1976 6 0 15.290566 -16.899037 3.541007 +7156 1976 4 0 15.456923 -17.854501 3.506824 +7157 1976 4 0 14.682578 -16.661722 4.258103 +7158 1977 6 0 -8.595092 -1.638190 20.084084 +7159 1977 4 0 -8.261779 -2.590969 20.168832 +7160 1977 4 0 -7.852015 -1.108351 20.332316 +7161 1978 6 0 -20.323788 -5.436750 0.324161 +7162 1978 4 0 -20.170009 -5.941054 1.094644 +7163 1978 4 0 -21.208252 -5.031900 0.601954 +7164 1979 6 0 -2.393237 8.004242 -11.498413 +7165 1979 4 0 -2.950404 8.660356 -11.054135 +7166 1979 4 0 -3.061318 7.581791 -12.073133 +7167 1980 6 0 -22.912771 3.860494 -12.441206 +7168 1980 4 0 -23.451777 3.037762 -12.348507 +7169 1980 4 0 -22.899565 4.032930 -13.430208 +7170 1981 6 0 20.362995 17.824512 -13.264003 +7171 1981 4 0 19.551615 17.496626 -12.844707 +7172 1981 4 0 20.082478 18.300222 -14.079166 +7173 1982 6 0 -24.585913 -0.746630 -0.896798 +7174 1982 4 0 -24.470331 -1.075027 -1.802806 +7175 1982 4 0 -23.819676 -0.946255 -0.373167 +7176 1983 6 0 -19.535789 -9.056148 -13.988499 +7177 1983 4 0 -19.846462 -8.673779 -13.166776 +7178 1983 4 0 -19.115510 -8.309283 -14.534612 +7179 1984 6 0 14.390022 6.679518 12.730957 +7180 1984 4 0 15.232081 6.289813 12.946155 +7181 1984 4 0 14.506655 7.667961 12.798775 +7182 1985 6 0 -13.116074 -0.366672 20.319004 +7183 1985 4 0 -12.270792 -0.638533 19.918398 +7184 1985 4 0 -13.671647 -1.133311 20.295523 +7185 1986 6 0 -8.591511 -19.336122 8.863799 +7186 1986 4 0 -9.117090 -20.010877 8.426692 +7187 1986 4 0 -7.862918 -19.753372 9.330648 +7188 1987 6 0 17.402278 20.652639 13.900402 +7189 1987 4 0 17.697788 21.603581 13.957892 +7190 1987 4 0 17.312316 20.500438 12.944824 +7191 1988 6 0 8.201262 9.483818 13.348516 +7192 1988 4 0 7.444873 10.096390 13.607594 +7193 1988 4 0 8.957598 10.011937 13.627746 +7194 1989 6 0 7.585535 14.800848 -12.327563 +7195 1989 4 0 7.057327 14.353832 -11.664194 +7196 1989 4 0 7.019891 15.502887 -12.695142 +7197 1990 6 0 -25.423194 -2.683175 -19.281520 +7198 1990 4 0 -25.154720 -3.154251 -18.493055 +7199 1990 4 0 -24.615481 -2.633480 -19.773081 +7200 1991 6 0 19.725045 -13.114787 8.444878 +7201 1991 4 0 19.513124 -14.034339 8.634210 +7202 1991 4 0 20.698306 -13.102042 8.543928 +7203 1992 6 0 20.099503 -20.282525 -15.985101 +7204 1992 4 0 20.708189 -19.889578 -15.319196 +7205 1992 4 0 19.393142 -19.575319 -15.986140 +7206 1993 6 0 12.771061 16.100563 -19.111418 +7207 1993 4 0 12.131597 16.778356 -19.314806 +7208 1993 4 0 12.464661 15.303336 -19.572804 +7209 1994 6 0 7.091753 -14.703139 17.991009 +7210 1994 4 0 7.807603 -15.309333 17.938259 +7211 1994 4 0 7.194027 -14.118016 17.231754 +7212 1995 6 0 -22.592481 8.686176 -7.047127 +7213 1995 4 0 -22.216240 9.064017 -6.202984 +7214 1995 4 0 -23.491060 9.070100 -7.232883 +7215 1996 6 0 -4.638462 -13.691402 17.535113 +7216 1996 4 0 -4.741933 -14.552763 17.998987 +7217 1996 4 0 -3.917812 -13.768318 16.891949 +7218 1997 6 0 15.674081 -9.755387 -16.113189 +7219 1997 4 0 16.400378 -9.301702 -15.729512 +7220 1997 4 0 15.141124 -9.061926 -16.542582 +7221 1998 6 0 -13.702316 -19.909047 -12.268941 +7222 1998 4 0 -14.359478 -19.319853 -12.555858 +7223 1998 4 0 -14.123812 -20.688800 -11.912022 +7224 1999 6 0 24.541571 12.760808 8.882057 +7225 1999 4 0 24.177431 13.512218 9.353984 +7226 1999 4 0 24.288780 12.867460 7.942115 +7227 2000 6 0 -7.687548 20.108508 10.397741 +7228 2000 4 0 -6.786045 20.459581 10.465576 +7229 2000 4 0 -7.840032 19.590481 9.619893 +7230 2001 6 0 17.691564 14.211194 -11.948720 +7231 2001 4 0 16.837678 14.621970 -11.842799 +7232 2001 4 0 18.118330 14.755742 -12.626475 +7233 2002 6 0 21.348057 -7.329463 -13.375832 +7234 2002 4 0 21.593345 -6.492239 -13.815720 +7235 2002 4 0 21.736068 -7.343951 -12.513154 +7236 2003 6 0 -19.887601 4.039241 4.011716 +7237 2003 4 0 -20.804227 3.899388 4.382950 +7238 2003 4 0 -19.888370 5.029157 3.892591 +7239 2004 6 0 -25.084134 8.583682 -19.308703 +7240 2004 4 0 -25.512658 8.302589 -20.191094 +7241 2004 4 0 -24.552230 7.802502 -19.104750 +7242 2005 6 0 9.783143 -8.944234 15.919722 +7243 2005 4 0 9.846305 -9.847677 16.313657 +7244 2005 4 0 10.422901 -8.539313 16.532052 +7245 2006 6 0 24.921152 14.233454 -9.328043 +7246 2006 4 0 25.485037 14.435637 -8.538860 +7247 2006 4 0 24.550831 15.052607 -9.617520 +7248 2007 6 0 -5.336150 -19.944956 -15.675499 +7249 2007 4 0 -4.550070 -20.475028 -15.352798 +7250 2007 4 0 -4.968558 -19.050199 -15.973828 +7251 2008 6 0 -15.773463 -12.281833 -13.129558 +7252 2008 4 0 -15.686354 -12.889867 -12.384071 +7253 2008 4 0 -15.452029 -12.783419 -13.894154 +7254 2009 6 0 -4.300139 -7.123836 -2.160106 +7255 2009 4 0 -3.342814 -7.235681 -2.390788 +7256 2009 4 0 -4.824947 -7.659223 -2.750865 +7257 2010 6 0 -25.789560 20.874236 19.526065 +7258 2010 4 0 -24.843357 21.124661 19.555308 +7259 2010 4 0 -26.065421 21.149679 18.673765 +7260 2011 6 0 -9.146229 1.424908 -20.523854 +7261 2011 4 0 -10.001499 1.119683 -20.181523 +7262 2011 4 0 -8.546249 0.921170 -20.019617 +7263 2012 6 0 26.101075 5.848590 12.988450 +7264 2012 4 0 26.554693 5.084410 12.637458 +7265 2012 4 0 25.161381 5.669725 12.803554 +7266 2013 6 0 9.006687 19.040346 -18.186210 +7267 2013 4 0 8.065932 18.907108 -18.115528 +7268 2013 4 0 9.047297 19.909251 -18.666859 +7269 2014 6 0 -7.293872 14.178171 -1.883075 +7270 2014 4 0 -6.467767 14.351226 -2.386146 +7271 2014 4 0 -7.610529 15.055318 -1.621187 +7272 2015 6 0 -6.991462 19.787403 0.500962 +7273 2015 4 0 -6.438660 19.949638 1.223968 +7274 2015 4 0 -7.711116 19.103046 0.704655 +7275 2016 6 0 27.160597 -2.308726 -10.478195 +7276 2016 4 0 26.892593 -1.628933 -9.894058 +7277 2016 4 0 26.370866 -2.910166 -10.699907 +7278 2017 6 0 20.720937 15.282200 -14.602248 +7279 2017 4 0 19.787625 15.378072 -14.861312 +7280 2017 4 0 21.253153 16.033456 -14.917484 +7281 2018 6 0 -1.717777 3.126430 19.684869 +7282 2018 4 0 -2.457020 3.742545 19.704262 +7283 2018 4 0 -1.981408 2.239558 19.670325 +7284 2019 6 0 -14.236932 -8.531350 -17.888137 +7285 2019 4 0 -13.483311 -8.743594 -17.293313 +7286 2019 4 0 -14.879621 -9.247417 -17.747177 +7287 2020 6 0 -4.783415 -4.020396 -20.532866 +7288 2020 4 0 -4.012136 -4.566525 -20.414031 +7289 2020 4 0 -5.530185 -4.500179 -20.351823 +7290 2021 6 0 -13.666695 2.341198 -19.917613 +7291 2021 4 0 -13.647430 2.522072 -20.842149 +7292 2021 4 0 -14.523681 2.756089 -19.651511 +7293 2022 6 0 3.688675 -20.632144 14.338255 +7294 2022 4 0 4.124765 -20.055049 14.958708 +7295 2022 4 0 3.773276 -21.474844 14.693545 +7296 2023 6 0 -20.711810 11.153254 -5.295425 +7297 2023 4 0 -20.997628 10.543621 -4.576628 +7298 2023 4 0 -20.872806 11.978037 -4.877765 +7299 2024 6 0 24.053294 -19.987538 -18.448521 +7300 2024 4 0 23.997797 -20.379984 -19.321399 +7301 2024 4 0 24.605029 -20.616521 -17.920358 +7302 2025 6 0 18.893096 0.346665 4.419514 +7303 2025 4 0 18.836810 -0.563948 4.138422 +7304 2025 4 0 19.384494 0.416823 5.258191 +7305 2026 6 0 1.611674 7.827775 17.729516 +7306 2026 4 0 1.683155 6.883076 17.518073 +7307 2026 4 0 0.776664 7.948423 18.173512 +7308 2027 6 0 9.885872 -10.367999 -15.423519 +7309 2027 4 0 9.747228 -11.080640 -16.152068 +7310 2027 4 0 9.165955 -9.782881 -15.477159 +7311 2028 6 0 -8.001025 -8.903978 20.363588 +7312 2028 4 0 -7.919331 -9.384725 21.262606 +7313 2028 4 0 -8.555002 -9.547097 19.892421 +7314 2029 6 0 -5.444250 -12.618432 -20.512332 +7315 2029 4 0 -4.642289 -13.086364 -20.688100 +7316 2029 4 0 -5.443229 -12.055754 -19.736438 +7317 2030 6 0 13.515262 -10.012095 19.152766 +7318 2030 4 0 12.845808 -9.927516 19.858658 +7319 2030 4 0 14.340617 -9.646593 19.590648 +7320 2031 6 0 -8.356973 -7.803379 16.925718 +7321 2031 4 0 -8.140830 -7.917106 15.999678 +7322 2031 4 0 -8.084091 -8.687693 17.308394 +7323 2032 6 0 19.760910 -2.370831 2.421662 +7324 2032 4 0 20.560599 -1.857333 2.578796 +7325 2032 4 0 19.273809 -1.863655 1.723372 +7326 2033 6 0 16.532929 9.397948 -13.603509 +7327 2033 4 0 16.407542 10.353638 -13.545246 +7328 2033 4 0 17.450225 9.202690 -13.801843 +7329 2034 6 0 3.043298 -8.545676 8.964253 +7330 2034 4 0 2.418694 -7.834314 8.742863 +7331 2034 4 0 3.163757 -8.907052 8.081541 +7332 2035 6 0 -5.314921 -13.601995 0.201579 +7333 2035 4 0 -4.416708 -13.534559 -0.042940 +7334 2035 4 0 -5.417418 -14.438498 0.657175 +7335 2036 6 0 1.416185 6.843538 -11.410595 +7336 2036 4 0 1.633970 7.742217 -11.087491 +7337 2036 4 0 0.761793 6.459053 -10.786036 +7338 2037 6 0 19.767922 9.421307 -8.193013 +7339 2037 4 0 19.914480 8.466041 -8.135440 +7340 2037 4 0 19.575103 9.558308 -9.177735 +7341 2038 6 0 26.172410 11.919029 3.610739 +7342 2038 4 0 25.535585 12.193435 4.240735 +7343 2038 4 0 26.042272 10.983029 3.549151 +7344 2039 6 0 -21.735841 2.144400 18.211620 +7345 2039 4 0 -22.104009 2.960860 18.654752 +7346 2039 4 0 -22.313927 1.460249 18.492995 +7347 2040 6 0 1.557972 -12.790578 15.622137 +7348 2040 4 0 0.853719 -13.365055 15.935999 +7349 2040 4 0 1.906483 -13.231160 14.910699 +7350 2041 6 0 -13.258859 4.104211 -2.315588 +7351 2041 4 0 -13.608254 4.812418 -2.986967 +7352 2041 4 0 -14.087487 3.646024 -2.095452 +7353 2042 6 0 -26.307679 -0.111768 -20.714469 +7354 2042 4 0 -25.812995 0.720645 -20.583269 +7355 2042 4 0 -25.528348 -0.678575 -20.909717 +7356 2043 6 0 11.642962 12.398152 -6.461792 +7357 2043 4 0 11.596820 12.230702 -5.538685 +7358 2043 4 0 12.552221 12.400971 -6.683261 +7359 2044 6 0 9.805562 12.056033 0.297197 +7360 2044 4 0 10.657658 12.469311 0.654830 +7361 2044 4 0 9.202541 11.759951 0.941289 +7362 2045 6 0 -6.826832 12.393010 9.213697 +7363 2045 4 0 -6.537792 11.811004 8.506850 +7364 2045 4 0 -6.100427 12.347418 9.835231 +7365 2046 6 0 20.133141 -17.531986 18.955618 +7366 2046 4 0 19.437169 -18.073233 18.517051 +7367 2046 4 0 20.798807 -17.276415 18.236384 +7368 2047 6 0 16.549382 -10.626162 16.457286 +7369 2047 4 0 16.551942 -9.717820 16.759418 +7370 2047 4 0 16.147566 -11.023294 17.252231 +7371 2048 6 0 1.789829 14.643494 -5.619552 +7372 2048 4 0 1.048933 14.228176 -6.039228 +7373 2048 4 0 1.669053 14.391952 -4.707740 +7374 2049 6 0 4.371658 -12.694698 -12.318562 +7375 2049 4 0 4.915573 -13.184619 -11.694576 +7376 2049 4 0 4.915130 -11.958781 -12.720896 +7377 2050 6 0 -11.293082 0.237019 -19.250596 +7378 2050 4 0 -11.966255 0.783547 -19.678369 +7379 2050 4 0 -11.548510 -0.704739 -19.364586 +7380 2051 6 0 -2.484806 -0.918295 -14.668621 +7381 2051 4 0 -2.177091 -1.152345 -15.589201 +7382 2051 4 0 -1.695025 -0.610144 -14.221845 +7383 2052 6 0 25.578482 -18.001184 -14.174826 +7384 2052 4 0 24.716923 -17.519582 -14.309086 +7385 2052 4 0 26.303012 -17.438870 -14.436407 +7386 2053 6 0 23.132217 17.040870 -8.595297 +7387 2053 4 0 23.143509 17.518773 -7.762629 +7388 2053 4 0 22.923741 16.132690 -8.372110 +7389 2054 6 0 2.923503 11.871856 -20.547177 +7390 2054 4 0 2.198503 11.234695 -20.236214 +7391 2054 4 0 3.511763 11.911115 -19.844001 +7392 2055 6 0 2.179585 4.144910 -11.877852 +7393 2055 4 0 2.151655 5.096818 -11.803012 +7394 2055 4 0 2.729899 3.974673 -12.667805 +7395 2056 6 0 26.669404 -11.624549 13.477594 +7396 2056 4 0 25.735733 -11.431455 13.654851 +7397 2056 4 0 27.077849 -11.550313 14.372992 +7398 2057 6 0 24.873075 -11.097731 10.824618 +7399 2057 4 0 25.209728 -11.897467 10.432443 +7400 2057 4 0 25.614915 -10.682030 11.193580 +7401 2058 6 0 -1.826162 -17.791623 4.511609 +7402 2058 4 0 -1.466714 -17.114337 3.985489 +7403 2058 4 0 -1.066332 -18.298254 4.813832 +7404 2059 6 0 24.895806 4.512131 -17.916870 +7405 2059 4 0 24.133889 5.103597 -18.006070 +7406 2059 4 0 25.725831 4.889044 -18.163865 +7407 2060 6 0 -20.306217 1.655909 -0.658591 +7408 2060 4 0 -19.365596 1.457605 -0.837148 +7409 2060 4 0 -20.259907 1.991986 0.211928 +7410 2061 6 0 13.312009 19.524936 16.387048 +7411 2061 4 0 13.933293 19.167357 15.722455 +7412 2061 4 0 13.259660 18.816564 17.092867 +7413 2062 6 0 -6.291960 0.181353 20.409012 +7414 2062 4 0 -5.886986 -0.391564 19.697954 +7415 2062 4 0 -6.191361 -0.287042 21.246927 +7416 2063 6 0 -11.925605 -14.118393 11.513337 +7417 2063 4 0 -12.390021 -13.899494 10.677619 +7418 2063 4 0 -11.499213 -13.318961 11.825704 +7419 2064 6 0 25.690900 -20.544963 -6.726643 +7420 2064 4 0 25.848636 -19.865858 -7.443635 +7421 2064 4 0 25.541265 -21.356361 -7.237324 +7422 2065 6 0 -10.266763 4.606069 -14.148088 +7423 2065 4 0 -10.666583 4.007171 -14.802051 +7424 2065 4 0 -10.592890 5.506386 -14.316808 +7425 2066 6 0 -13.700313 11.443217 -7.703372 +7426 2066 4 0 -14.305805 11.566376 -8.451855 +7427 2066 4 0 -13.797593 10.519533 -7.520760 +7428 2067 6 0 19.896960 -5.260769 2.047938 +7429 2067 4 0 20.639909 -5.673868 2.498703 +7430 2067 4 0 19.902578 -4.275845 1.972121 +7431 2068 6 0 27.483595 4.667361 6.350280 +7432 2068 4 0 27.612327 3.821689 6.792070 +7433 2068 4 0 27.474096 5.241160 7.041075 +7434 2069 6 0 16.838162 -11.125573 -1.977415 +7435 2069 4 0 17.018636 -10.652759 -1.169733 +7436 2069 4 0 17.083147 -12.071800 -1.748280 +7437 2070 6 0 -3.825915 15.193309 16.332435 +7438 2070 4 0 -3.868970 16.088775 15.893612 +7439 2070 4 0 -2.922251 14.779372 16.138541 +7440 2071 6 0 -4.999597 -20.685905 -5.935566 +7441 2071 4 0 -5.618635 -20.401156 -6.580918 +7442 2071 4 0 -5.077868 -21.673790 -5.909799 +7443 2072 6 0 -20.562039 0.140160 5.669443 +7444 2072 4 0 -20.686050 0.843366 6.344794 +7445 2072 4 0 -20.730893 0.582485 4.804185 +7446 2073 6 0 -6.671827 11.535978 19.876374 +7447 2073 4 0 -7.261521 11.364859 20.662982 +7448 2073 4 0 -7.266511 12.144069 19.377508 +7449 2074 6 0 4.191517 -2.479488 13.355524 +7450 2074 4 0 4.884007 -2.164404 14.019008 +7451 2074 4 0 3.372874 -2.220309 13.814811 +7452 2075 6 0 8.749947 16.191041 8.535964 +7453 2075 4 0 8.732297 16.863275 9.229059 +7454 2075 4 0 8.691576 16.634682 7.644507 +7455 2076 6 0 -25.961494 14.282183 -15.383787 +7456 2076 4 0 -25.985646 15.282436 -15.164995 +7457 2076 4 0 -26.833664 13.915918 -15.151600 +7458 2077 6 0 27.385198 14.529212 8.142639 +7459 2077 4 0 26.412128 14.399556 8.083311 +7460 2077 4 0 27.495002 15.490751 8.294493 +7461 2078 6 0 14.126472 -14.702927 -8.987957 +7462 2078 4 0 14.925682 -14.560974 -8.448204 +7463 2078 4 0 13.489976 -15.067821 -8.401821 +7464 2079 6 0 -23.336636 -6.121383 -20.639900 +7465 2079 4 0 -22.869154 -5.535755 -20.072156 +7466 2079 4 0 -24.124908 -6.450781 -20.113919 +7467 2080 6 0 -0.774826 -13.203604 16.888646 +7468 2080 4 0 -1.468020 -13.376023 16.234547 +7469 2080 4 0 -0.931871 -12.304587 17.229608 +7470 2081 6 0 9.061125 5.283331 17.143683 +7471 2081 4 0 9.916783 5.174639 16.603587 +7472 2081 4 0 8.778289 6.220910 17.070877 +7473 2082 6 0 -25.315423 9.781118 -15.359265 +7474 2082 4 0 -24.471315 9.264358 -15.331486 +7475 2082 4 0 -25.606191 9.792640 -14.434801 +7476 2083 6 0 -10.967554 -10.738154 -9.731527 +7477 2083 4 0 -11.765483 -10.936834 -9.181748 +7478 2083 4 0 -10.379375 -10.133651 -9.266538 +7479 2084 6 0 -1.488275 3.623351 -16.767913 +7480 2084 4 0 -0.882657 4.371387 -16.669247 +7481 2084 4 0 -1.492403 3.254437 -17.674715 +7482 2085 6 0 12.452312 -19.040060 3.375147 +7483 2085 4 0 12.871486 -19.871899 3.246114 +7484 2085 4 0 11.754508 -18.893125 2.776534 +7485 2086 6 0 -15.573729 -12.221722 0.716973 +7486 2086 4 0 -15.002380 -12.832434 0.254063 +7487 2086 4 0 -16.254430 -12.772029 1.034977 +7488 2087 6 0 13.752256 -4.097413 -18.870896 +7489 2087 4 0 14.581949 -3.712772 -18.513163 +7490 2087 4 0 13.271688 -3.261042 -18.845949 +7491 2088 6 0 -21.641111 -0.680590 0.005430 +7492 2088 4 0 -21.093432 0.076279 -0.365044 +7493 2088 4 0 -21.445828 -0.814377 0.968664 +7494 2089 6 0 15.724559 3.520455 6.328412 +7495 2089 4 0 14.921141 3.234676 6.784467 +7496 2089 4 0 15.461693 3.698167 5.450324 +7497 2090 6 0 -27.214078 -11.147965 5.082767 +7498 2090 4 0 -26.390239 -11.278816 5.572480 +7499 2090 4 0 -27.321203 -12.054005 4.683669 +7500 2091 6 0 13.328280 7.582484 -18.567300 +7501 2091 4 0 14.185844 7.864153 -18.950423 +7502 2091 4 0 12.732777 7.507446 -19.290185 +7503 2092 6 0 -16.683838 -4.586561 -13.916725 +7504 2092 4 0 -16.820834 -4.523796 -14.842726 +7505 2092 4 0 -15.965498 -5.193692 -13.685180 +7506 2093 6 0 -19.170260 12.551147 12.092952 +7507 2093 4 0 -19.387562 11.609567 12.048568 +7508 2093 4 0 -18.718827 12.726237 11.286473 +7509 2094 6 0 -2.873940 -18.817391 -0.630738 +7510 2094 4 0 -2.585106 -18.870724 -1.613607 +7511 2094 4 0 -3.793192 -19.000736 -0.761036 +7512 2095 6 0 -15.440453 11.669180 16.607856 +7513 2095 4 0 -15.211613 10.749409 16.748182 +7514 2095 4 0 -15.523689 11.929189 17.511524 +7515 2096 6 0 0.676885 9.019049 7.967361 +7516 2096 4 0 -0.188437 8.924038 8.296825 +7517 2096 4 0 1.100577 8.314509 8.389075 +7518 2097 6 0 -12.658914 -13.169855 -2.443871 +7519 2097 4 0 -13.329719 -13.325087 -1.824892 +7520 2097 4 0 -12.438077 -13.988972 -2.754186 +7521 2098 6 0 -16.248882 -11.627131 16.273828 +7522 2098 4 0 -16.071661 -12.035171 17.149648 +7523 2098 4 0 -15.584055 -10.905357 16.247158 +7524 2099 6 0 7.587639 18.040490 0.648325 +7525 2099 4 0 7.127313 17.621736 1.427370 +7526 2099 4 0 8.472509 18.025945 0.938181 +7527 2100 6 0 -21.260403 -7.316165 -17.769548 +7528 2100 4 0 -21.464936 -6.579095 -18.356837 +7529 2100 4 0 -21.090642 -6.945093 -16.896335 +7530 2101 6 0 16.016635 -1.860641 -2.314369 +7531 2101 4 0 16.938184 -1.677711 -2.476393 +7532 2101 4 0 15.526197 -1.857629 -3.158683 +7533 2102 6 0 4.492292 -4.776655 -20.071507 +7534 2102 4 0 4.666835 -4.194018 -19.383577 +7535 2102 4 0 5.379154 -5.033244 -20.511472 +7536 2103 6 0 -15.720931 20.128785 -10.578428 +7537 2103 4 0 -15.839702 20.941641 -10.100642 +7538 2103 4 0 -16.315376 20.178519 -11.349297 +7539 2104 6 0 -26.439198 6.163682 -9.860618 +7540 2104 4 0 -25.627768 6.495816 -9.484731 +7541 2104 4 0 -26.911803 6.981208 -10.036013 +7542 2105 6 0 9.335945 11.329795 -3.722917 +7543 2105 4 0 8.644451 12.059424 -3.617751 +7544 2105 4 0 8.888513 10.554570 -4.126032 +7545 2106 6 0 -13.380471 10.478242 6.861111 +7546 2106 4 0 -13.220641 10.103750 7.786550 +7547 2106 4 0 -13.207886 11.438191 6.902907 +7548 2107 6 0 3.128674 -13.794262 17.620598 +7549 2107 4 0 2.638158 -13.260660 17.056399 +7550 2107 4 0 3.597573 -13.167888 18.155001 +7551 2108 6 0 -15.640110 12.239687 19.252890 +7552 2108 4 0 -15.744305 13.228589 19.346365 +7553 2108 4 0 -16.382496 11.838747 19.767704 +7554 2109 6 0 2.784908 9.116859 -10.197973 +7555 2109 4 0 3.297798 8.414513 -9.705521 +7556 2109 4 0 3.275248 9.528201 -10.883691 +7557 2110 6 0 -7.890712 -7.603783 -17.743202 +7558 2110 4 0 -7.124761 -7.008882 -17.935759 +7559 2110 4 0 -8.550851 -7.045750 -18.114982 +7560 2111 6 0 -13.699956 -6.291585 9.543158 +7561 2111 4 0 -14.665087 -6.196216 9.729838 +7562 2111 4 0 -13.399326 -5.367978 9.707420 +7563 2112 6 0 20.465588 -10.458716 3.145054 +7564 2112 4 0 20.979944 -10.701349 3.922596 +7565 2112 4 0 19.551694 -10.315318 3.519540 +7566 2113 6 0 -21.770772 17.965042 -17.112890 +7567 2113 4 0 -20.830189 18.026694 -16.817043 +7568 2113 4 0 -22.065602 18.901599 -17.079860 +7569 2114 6 0 -14.835473 -2.018047 -6.153382 +7570 2114 4 0 -15.436027 -2.198495 -6.881730 +7571 2114 4 0 -15.436197 -1.848312 -5.360006 +7572 2115 6 0 4.864928 -7.193456 16.503727 +7573 2115 4 0 4.980211 -6.246101 16.323915 +7574 2115 4 0 5.579734 -7.640000 16.024530 +7575 2116 6 0 19.120349 11.030815 -15.362470 +7576 2116 4 0 19.294800 10.826080 -16.279672 +7577 2116 4 0 19.622213 10.380633 -14.881548 +7578 2117 6 0 -0.977018 13.926628 -7.123442 +7579 2117 4 0 -1.852314 14.048847 -6.757564 +7580 2117 4 0 -1.008005 14.146864 -8.050474 +7581 2118 6 0 1.836955 20.649010 5.205237 +7582 2118 4 0 1.357046 19.856623 4.900209 +7583 2118 4 0 2.481382 20.946625 4.486330 +7584 2119 6 0 22.248352 0.089789 14.254305 +7585 2119 4 0 21.482126 0.622149 14.431275 +7586 2119 4 0 22.760633 -0.073685 15.065722 +7587 2120 6 0 4.943704 7.039238 -17.178880 +7588 2120 4 0 4.132510 7.341202 -17.610714 +7589 2120 4 0 5.316936 6.264192 -17.636046 +7590 2121 6 0 -13.513178 20.872697 -6.966661 +7591 2121 4 0 -12.917889 20.159554 -6.816410 +7592 2121 4 0 -13.438901 21.399519 -6.129707 +7593 2122 6 0 -26.783745 1.737872 -10.173855 +7594 2122 4 0 -27.406703 1.045834 -9.889439 +7595 2122 4 0 -26.563015 2.284868 -9.419251 +7596 2123 6 0 16.895897 -14.537239 -4.916419 +7597 2123 4 0 17.186118 -13.833540 -5.508216 +7598 2123 4 0 17.149098 -15.342322 -5.413605 +7599 2124 6 0 26.817205 -3.814990 8.332532 +7600 2124 4 0 26.423093 -3.721401 9.229654 +7601 2124 4 0 26.751966 -4.740274 8.261936 +7602 2125 6 0 26.660512 -8.107918 -18.699113 +7603 2125 4 0 27.143708 -8.664547 -19.302869 +7604 2125 4 0 27.318084 -7.817236 -18.086633 +7605 2126 6 0 10.208858 -14.799716 -11.685147 +7606 2126 4 0 10.229559 -13.857528 -11.605014 +7607 2126 4 0 10.909011 -14.996510 -12.361468 +7608 2127 6 0 -7.122161 12.606835 5.012358 +7609 2127 4 0 -6.742894 13.446553 5.343573 +7610 2127 4 0 -6.707272 11.958739 5.582727 +7611 2128 6 0 -1.649859 -17.353593 -19.765333 +7612 2128 4 0 -1.703196 -17.292489 -18.801764 +7613 2128 4 0 -0.740888 -17.269565 -19.956034 +7614 2129 6 0 -25.578511 10.750973 19.368175 +7615 2129 4 0 -25.759953 9.955006 18.909465 +7616 2129 4 0 -26.373616 10.876703 19.816004 +7617 2130 6 0 -15.512850 14.948587 19.552015 +7618 2130 4 0 -14.592416 15.278921 19.862734 +7619 2130 4 0 -15.517720 15.251241 18.670365 +7620 2131 6 0 -22.108713 15.986768 -19.097538 +7621 2131 4 0 -21.973356 16.492171 -18.298729 +7622 2131 4 0 -22.275608 15.084558 -18.884443 +7623 2132 6 0 -24.432040 1.967038 -20.402572 +7624 2132 4 0 -24.316057 2.005234 -19.442897 +7625 2132 4 0 -23.617246 1.596664 -20.796357 +7626 2133 6 0 0.976021 12.002153 3.317883 +7627 2133 4 0 1.233810 12.944966 3.271665 +7628 2133 4 0 1.053167 11.659322 4.215764 +7629 2134 6 0 -22.848328 -11.507211 20.792792 +7630 2134 4 0 -22.031691 -11.288244 20.331458 +7631 2134 4 0 -23.563342 -11.121670 20.237130 +7632 2135 6 0 5.372331 -6.390447 8.998397 +7633 2135 4 0 5.156327 -6.136745 8.105017 +7634 2135 4 0 4.867716 -7.183706 9.243399 +7635 2136 6 0 -5.077546 13.038740 -9.712665 +7636 2136 4 0 -4.384730 12.918197 -10.436683 +7637 2136 4 0 -5.739596 12.361322 -9.833579 +7638 2137 6 0 4.313864 -17.817036 1.578679 +7639 2137 4 0 3.642179 -17.175797 1.786403 +7640 2137 4 0 4.014882 -18.443226 0.872394 +7641 2138 6 0 -10.825600 -3.788470 12.345548 +7642 2138 4 0 -11.474785 -4.350281 12.848087 +7643 2138 4 0 -11.121245 -2.913918 12.572141 +7644 2139 6 0 -10.308333 17.332588 -19.108687 +7645 2139 4 0 -9.699779 18.058376 -18.760246 +7646 2139 4 0 -9.696827 16.600840 -19.450737 +7647 2140 6 0 20.367843 11.704165 19.663819 +7648 2140 4 0 19.894726 12.360595 20.126357 +7649 2140 4 0 20.501092 12.010854 18.743343 +7650 2141 6 0 4.454769 15.397642 -5.721382 +7651 2141 4 0 5.096605 14.668068 -5.812036 +7652 2141 4 0 3.560506 15.012254 -5.700523 +7653 2142 6 0 -10.186828 -2.388640 -11.736429 +7654 2142 4 0 -10.325119 -2.558008 -12.705589 +7655 2142 4 0 -10.806607 -2.883931 -11.193573 +7656 2143 6 0 -24.912356 3.520925 11.318625 +7657 2143 4 0 -24.410292 4.337248 11.078911 +7658 2143 4 0 -25.009199 2.856626 10.581227 +7659 2144 6 0 25.624082 -17.044203 16.133293 +7660 2144 4 0 26.569447 -17.105418 15.881796 +7661 2144 4 0 25.526730 -16.778186 17.038064 +7662 2145 6 0 -18.172292 -12.061346 20.656118 +7663 2145 4 0 -19.064000 -11.714052 20.415716 +7664 2145 4 0 -18.318393 -12.531580 21.542312 +7665 2146 6 0 -2.771360 17.065768 -3.605776 +7666 2146 4 0 -3.498372 16.467521 -3.261648 +7667 2146 4 0 -3.165333 17.613939 -4.263088 +7668 2147 6 0 3.828793 -18.285133 -12.035298 +7669 2147 4 0 4.572657 -18.613626 -12.559285 +7670 2147 4 0 4.121067 -17.462806 -11.547371 +7671 2148 6 0 6.372209 19.895468 -0.828574 +7672 2148 4 0 6.671245 19.260688 -0.181419 +7673 2148 4 0 6.498252 20.741942 -0.410853 +7674 2149 6 0 -26.077165 -2.986273 -6.579517 +7675 2149 4 0 -26.530567 -3.662357 -7.045915 +7676 2149 4 0 -25.278966 -3.412687 -6.199533 +7677 2150 6 0 1.066751 -11.604098 -7.437054 +7678 2150 4 0 0.780778 -12.103600 -8.170135 +7679 2150 4 0 0.490797 -10.859423 -7.390052 +7680 2151 6 0 26.435886 -19.880105 20.436273 +7681 2151 4 0 27.363986 -19.578464 20.393790 +7682 2151 4 0 25.964716 -19.053915 20.333618 +7683 2152 6 0 3.948373 18.634138 -19.227666 +7684 2152 4 0 4.776804 18.681442 -18.670875 +7685 2152 4 0 3.724437 19.545742 -19.268399 +7686 2153 6 0 6.895853 -2.593776 -14.926776 +7687 2153 4 0 6.939228 -1.872325 -14.297950 +7688 2153 4 0 5.922138 -2.668665 -14.881269 +7689 2154 6 0 -11.002838 -0.157918 -15.377800 +7690 2154 4 0 -11.039095 0.271800 -14.533222 +7691 2154 4 0 -11.858546 -0.101002 -15.791180 +7692 2155 6 0 -23.278682 -12.335400 16.986956 +7693 2155 4 0 -23.969958 -13.046960 17.013455 +7694 2155 4 0 -23.739191 -11.494386 17.223424 +7695 2156 6 0 -8.733901 10.961189 15.538536 +7696 2156 4 0 -9.664866 10.721280 15.448379 +7697 2156 4 0 -8.333145 10.082375 15.772687 +7698 2157 6 0 -18.407350 15.043497 -16.093194 +7699 2157 4 0 -17.602548 15.511802 -15.718946 +7700 2157 4 0 -18.860502 14.688871 -15.320254 +7701 2158 6 0 -7.717846 -19.245322 6.135762 +7702 2158 4 0 -8.369623 -18.587554 5.773934 +7703 2158 4 0 -8.005786 -19.439467 7.014406 +7704 2159 6 0 27.537835 -2.244938 17.802365 +7705 2159 4 0 26.595262 -2.186775 17.618048 +7706 2159 4 0 27.566413 -2.809518 18.555718 +7707 2160 6 0 14.035672 -13.942494 -5.025234 +7708 2160 4 0 13.436663 -14.726681 -5.087496 +7709 2160 4 0 14.937241 -14.361386 -5.014306 +7710 2161 6 0 -21.221588 13.030355 13.864922 +7711 2161 4 0 -20.364838 12.937985 13.362956 +7712 2161 4 0 -21.556169 12.132892 13.747752 +7713 2162 6 0 3.382602 17.477038 1.971338 +7714 2162 4 0 2.998725 16.711070 1.403757 +7715 2162 4 0 3.440438 18.202483 1.331855 +7716 2163 6 0 -27.449290 2.763472 -5.473864 +7717 2163 4 0 -26.862644 2.952928 -6.231930 +7718 2163 4 0 -28.220354 2.416823 -5.903707 +7719 2164 6 0 21.309171 1.208177 18.719816 +7720 2164 4 0 20.908787 2.039246 18.612886 +7721 2164 4 0 21.184556 0.863131 19.641302 +7722 2165 6 0 11.888692 16.675087 -12.603821 +7723 2165 4 0 10.999248 16.541633 -13.021832 +7724 2165 4 0 11.878107 16.199062 -11.723643 +7725 2166 6 0 15.960563 -12.459489 -12.277920 +7726 2166 4 0 16.878686 -12.644050 -12.500987 +7727 2166 4 0 16.057647 -11.602612 -11.757235 +7728 2167 6 0 -12.060427 7.034589 4.513332 +7729 2167 4 0 -11.557894 7.520852 3.823017 +7730 2167 4 0 -11.343768 6.740188 5.138402 +7731 2168 6 0 -8.561873 -15.574827 18.511819 +7732 2168 4 0 -8.355748 -14.726119 18.975068 +7733 2168 4 0 -9.321577 -15.327632 17.928691 +7734 2169 6 0 26.839386 -9.977418 -11.801214 +7735 2169 4 0 27.210714 -10.886833 -12.066458 +7736 2169 4 0 26.680237 -9.508287 -12.672668 +7737 2170 6 0 19.487816 -4.295750 -10.653772 +7738 2170 4 0 19.155987 -5.040203 -11.186489 +7739 2170 4 0 19.101905 -4.274245 -9.721574 +7740 2171 6 0 -2.617367 -9.196096 12.807798 +7741 2171 4 0 -3.053330 -8.849761 12.003083 +7742 2171 4 0 -1.757135 -8.732443 12.734709 +7743 2172 6 0 6.741614 9.283527 -17.879312 +7744 2172 4 0 6.380288 9.612761 -18.710343 +7745 2172 4 0 6.169408 8.510946 -17.615438 +7746 2173 6 0 -15.244518 -2.348788 -16.411194 +7747 2173 4 0 -15.286492 -3.293206 -16.627416 +7748 2173 4 0 -16.141604 -2.133344 -16.101761 +7749 2174 6 0 24.076224 14.005333 -20.764432 +7750 2174 4 0 23.579840 13.567519 -20.086274 +7751 2174 4 0 24.304722 13.264661 -21.387917 +7752 2175 6 0 5.197586 -0.122428 -17.048391 +7753 2175 4 0 5.961074 0.070496 -16.498322 +7754 2175 4 0 4.803638 0.707910 -17.262899 +7755 2176 6 0 -12.626531 20.869184 -20.635254 +7756 2176 4 0 -12.565754 20.478495 -19.764243 +7757 2176 4 0 -13.248230 21.560435 -20.592028 +7758 2177 6 0 -6.742302 15.365874 -8.317692 +7759 2177 4 0 -6.373557 14.699314 -8.910768 +7760 2177 4 0 -7.355781 15.918239 -8.809096 +7761 2178 6 0 -8.968953 -3.618531 16.586721 +7762 2178 4 0 -8.318587 -4.203738 17.052583 +7763 2178 4 0 -8.772937 -2.703569 16.930654 +7764 2179 6 0 4.646490 -13.425952 -20.543948 +7765 2179 4 0 5.006101 -13.053008 -19.771175 +7766 2179 4 0 4.114028 -14.244399 -20.306406 +7767 2180 6 0 20.560148 15.165785 18.388964 +7768 2180 4 0 20.026901 15.914780 18.133927 +7769 2180 4 0 20.137478 14.695974 19.131845 +7770 2181 6 0 16.253616 13.647989 17.466410 +7771 2181 4 0 16.144396 14.607506 17.611846 +7772 2181 4 0 15.603177 13.394335 16.728326 +7773 2182 6 0 -2.493112 -10.958918 18.158226 +7774 2182 4 0 -2.871350 -10.325469 17.572446 +7775 2182 4 0 -3.230138 -11.343072 18.670608 +7776 2183 6 0 24.417011 1.731847 15.781773 +7777 2183 4 0 24.256339 1.199810 16.598463 +7778 2183 4 0 24.103762 2.612690 16.033534 +7779 2184 6 0 23.869641 5.093835 -10.829152 +7780 2184 4 0 23.849127 5.899360 -10.350720 +7781 2184 4 0 24.806312 4.827153 -11.005653 +7782 2185 6 0 -25.326011 -10.985445 0.393748 +7783 2185 4 0 -24.487021 -11.323998 0.018652 +7784 2185 4 0 -25.846018 -10.577330 -0.299092 +7785 2186 6 0 -22.140365 -4.015548 -19.394205 +7786 2186 4 0 -21.298001 -3.731962 -19.753685 +7787 2186 4 0 -22.037014 -3.787820 -18.464135 +7788 2187 6 0 16.480100 17.378886 -8.149325 +7789 2187 4 0 15.944629 17.865308 -8.816984 +7790 2187 4 0 17.136048 16.933781 -8.707099 +7791 2188 6 0 9.225758 13.395457 -14.366037 +7792 2188 4 0 8.369757 13.485099 -14.794251 +7793 2188 4 0 9.149310 12.977217 -13.491919 +7794 2189 6 0 -11.512364 7.735604 17.233390 +7795 2189 4 0 -11.580776 7.745448 18.221759 +7796 2189 4 0 -10.572713 7.856344 17.057877 +7797 2190 6 0 22.313965 -17.567699 -18.743216 +7798 2190 4 0 22.795472 -18.390700 -18.665650 +7799 2190 4 0 21.527641 -17.771604 -19.283408 +7800 2191 6 0 26.008630 -8.991349 -9.190478 +7801 2191 4 0 26.251546 -9.200527 -10.105321 +7802 2191 4 0 25.207812 -9.493737 -9.000776 +7803 2192 6 0 16.930474 19.046264 7.447647 +7804 2192 4 0 16.385483 19.298108 8.210284 +7805 2192 4 0 17.081495 19.851182 6.876771 +7806 2193 6 0 -6.878192 14.458044 -14.342832 +7807 2193 4 0 -6.947724 15.178650 -14.986529 +7808 2193 4 0 -6.902494 14.876539 -13.459345 +7809 2194 6 0 -2.603745 -0.170130 11.118461 +7810 2194 4 0 -2.603735 0.193993 10.245898 +7811 2194 4 0 -2.301286 0.557857 11.700540 +7812 2195 6 0 -18.658918 6.935889 12.709416 +7813 2195 4 0 -18.611105 7.903442 12.826990 +7814 2195 4 0 -17.731206 6.682204 12.672567 +7815 2196 6 0 8.242150 20.321564 16.671943 +7816 2196 4 0 8.085884 19.395160 16.403784 +7817 2196 4 0 9.204603 20.443804 16.719883 +7818 2197 6 0 -26.194647 -1.598660 12.827976 +7819 2197 4 0 -25.470850 -1.539447 12.228660 +7820 2197 4 0 -26.434617 -2.532329 12.905279 +7821 2198 6 0 18.147255 11.834318 16.939503 +7822 2198 4 0 17.684791 12.638752 17.229443 +7823 2198 4 0 19.094703 11.992223 16.922098 +7824 2199 6 0 -24.103113 17.414200 -20.406032 +7825 2199 4 0 -24.841847 16.822155 -20.721607 +7826 2199 4 0 -23.364705 16.873068 -20.183752 +7827 2200 6 0 -20.188758 19.419367 -3.947439 +7828 2200 4 0 -20.092108 20.138589 -4.627770 +7829 2200 4 0 -20.779520 18.760391 -4.305720 +7830 2201 6 0 -19.169152 16.892293 -12.706791 +7831 2201 4 0 -18.376967 16.525250 -12.263419 +7832 2201 4 0 -19.451828 16.244073 -13.317784 +7833 2202 6 0 3.042793 -9.624584 6.339287 +7834 2202 4 0 2.126469 -9.764000 6.059404 +7835 2202 4 0 3.422607 -10.448883 6.082030 +7836 2203 6 0 26.796575 -0.250362 10.146355 +7837 2203 4 0 27.695465 -0.487351 9.790163 +7838 2203 4 0 26.991766 0.015930 11.058370 +7839 2204 6 0 -2.724018 -17.347993 -17.041468 +7840 2204 4 0 -3.685391 -17.148462 -17.004347 +7841 2204 4 0 -2.333214 -17.040061 -16.217705 +7842 2205 6 0 22.693834 -19.258880 -8.334918 +7843 2205 4 0 23.207274 -18.747223 -7.672504 +7844 2205 4 0 21.922700 -19.482635 -7.787257 +7845 2206 6 0 10.650819 14.245326 -8.863815 +7846 2206 4 0 10.590380 14.958254 -9.492462 +7847 2206 4 0 9.797431 14.052470 -8.521894 +7848 2207 6 0 21.896317 10.846424 11.520743 +7849 2207 4 0 22.820423 10.614982 11.723752 +7850 2207 4 0 21.512259 10.848333 12.397036 +7851 2208 6 0 -16.629808 6.024934 -16.061930 +7852 2208 4 0 -16.979035 6.163556 -15.154311 +7853 2208 4 0 -16.556800 6.853702 -16.565081 +7854 2209 6 0 -24.056464 -15.267357 -3.334116 +7855 2209 4 0 -24.017471 -15.426759 -2.411717 +7856 2209 4 0 -23.826595 -16.112409 -3.791556 +7857 2210 6 0 -24.814205 14.617559 -6.421721 +7858 2210 4 0 -24.613019 15.462145 -6.916680 +7859 2210 4 0 -25.784459 14.689331 -6.455648 +7860 2211 6 0 12.539335 -4.690091 16.952299 +7861 2211 4 0 12.874872 -3.959104 17.433778 +7862 2211 4 0 13.165313 -5.396450 16.984519 +7863 2212 6 0 27.426473 -20.349285 -4.187459 +7864 2212 4 0 26.932613 -20.185019 -4.988935 +7865 2212 4 0 27.020619 -19.915963 -3.444392 +7866 2213 6 0 -25.378069 18.390923 12.676602 +7867 2213 4 0 -25.468295 18.108442 13.617931 +7868 2213 4 0 -26.284264 18.454249 12.373374 +7869 2214 6 0 2.358488 15.655904 0.172343 +7870 2214 4 0 1.576275 15.538047 -0.330180 +7871 2214 4 0 2.949284 15.115348 -0.279388 +7872 2215 6 0 17.823860 -16.181961 4.219054 +7873 2215 4 0 16.871832 -16.285669 3.895196 +7874 2215 4 0 18.296855 -16.171292 3.367102 +7875 2216 6 0 -13.185175 11.185524 20.273552 +7876 2216 4 0 -12.491020 11.326572 19.606343 +7877 2216 4 0 -14.008783 11.327741 19.799749 +7878 2217 6 0 -16.946375 18.382248 -17.880917 +7879 2217 4 0 -16.601871 19.114714 -17.373712 +7880 2217 4 0 -17.112525 18.719683 -18.756566 +7881 2218 6 0 4.139489 13.924517 -8.158999 +7882 2218 4 0 3.276763 13.674016 -7.871220 +7883 2218 4 0 4.619548 13.009700 -8.222873 +7884 2219 6 0 19.195530 19.194186 -15.410073 +7885 2219 4 0 19.530087 20.044690 -15.698710 +7886 2219 4 0 18.880211 18.717599 -16.173654 +7887 2220 6 0 22.465366 -15.697985 -16.572314 +7888 2220 4 0 22.341005 -16.447983 -17.175221 +7889 2220 4 0 23.268415 -15.298896 -16.787665 +7890 2221 6 0 -6.168779 -9.840021 -9.350190 +7891 2221 4 0 -6.138060 -10.776075 -9.519650 +7892 2221 4 0 -5.375773 -9.424169 -9.650695 +7893 2222 6 0 25.209173 18.017697 -14.898072 +7894 2222 4 0 24.521605 17.467415 -14.490123 +7895 2222 4 0 25.669461 17.420196 -15.513375 +7896 2223 6 0 1.750289 -0.354167 -16.972701 +7897 2223 4 0 1.941430 -1.107141 -17.603779 +7898 2223 4 0 1.332140 0.330238 -17.528621 +7899 2224 6 0 18.682749 11.765475 10.852294 +7900 2224 4 0 19.563556 11.904202 10.494828 +7901 2224 4 0 18.677947 10.845188 11.223074 +7902 2225 6 0 -9.368425 16.562190 4.853452 +7903 2225 4 0 -8.407375 16.292116 4.842479 +7904 2225 4 0 -9.332928 17.502581 4.563723 +7905 2226 6 0 -14.320728 -5.516222 -17.892457 +7906 2226 4 0 -14.106677 -5.147397 -18.800379 +7907 2226 4 0 -14.225038 -6.471192 -17.943054 +7908 2227 6 0 -22.779663 -5.587037 4.961004 +7909 2227 4 0 -23.387774 -5.905882 4.279957 +7910 2227 4 0 -22.003636 -6.116854 4.731429 +7911 2228 6 0 1.608693 14.675487 10.806060 +7912 2228 4 0 2.333564 15.322059 10.910925 +7913 2228 4 0 1.191042 14.647480 11.723121 +7914 2229 6 0 -19.989851 14.272748 -13.831000 +7915 2229 4 0 -20.108765 14.145345 -12.856725 +7916 2229 4 0 -20.810178 14.265544 -14.251075 +7917 2230 6 0 -0.277500 6.116052 -20.054497 +7918 2230 4 0 -1.205482 6.025573 -19.750342 +7919 2230 4 0 0.030270 6.890733 -19.590961 +7920 2231 6 0 -23.218686 16.925049 -14.531729 +7921 2231 4 0 -24.154801 17.137589 -14.620012 +7922 2231 4 0 -22.798436 17.177619 -15.342960 +7923 2232 6 0 14.465041 -13.890297 11.092988 +7924 2232 4 0 14.125737 -13.087596 11.450092 +7925 2232 4 0 14.769204 -13.729760 10.198115 +7926 2233 6 0 -19.342535 19.484499 18.315509 +7927 2233 4 0 -18.817282 19.354539 19.111327 +7928 2233 4 0 -19.942353 18.726732 18.320837 +7929 2234 6 0 0.909574 12.732606 15.451247 +7930 2234 4 0 0.713888 11.749814 15.284439 +7931 2234 4 0 1.425345 12.740199 16.283139 +7932 2235 6 0 -2.274926 14.829696 20.985211 +7933 2235 4 0 -2.781123 13.962453 20.790809 +7934 2235 4 0 -2.630126 15.421882 20.359114 +7935 2236 6 0 7.507399 6.793027 13.609399 +7936 2236 4 0 7.518937 7.728154 13.813229 +7937 2236 4 0 8.443553 6.424691 13.587889 +7938 2237 6 0 12.870660 -12.764019 -10.964166 +7939 2237 4 0 12.942835 -13.465015 -11.598871 +7940 2237 4 0 13.227628 -13.197338 -10.244586 +7941 2238 6 0 8.913179 -11.919018 -6.239675 +7942 2238 4 0 8.887002 -11.850316 -5.252925 +7943 2238 4 0 8.813455 -11.004941 -6.499380 +7944 2239 6 0 -25.746417 7.206326 5.578919 +7945 2239 4 0 -25.082293 6.620904 5.823246 +7946 2239 4 0 -26.564541 6.922453 6.051858 +7947 2240 6 0 25.894755 9.257899 3.861774 +7948 2240 4 0 26.648604 8.789353 3.465470 +7949 2240 4 0 25.145952 8.756940 3.475241 +7950 2241 6 0 -8.830905 19.535286 -18.058852 +7951 2241 4 0 -7.932809 19.419232 -17.567730 +7952 2241 4 0 -8.446850 19.854198 -18.903385 +7953 2242 6 0 18.592621 -6.587479 -13.125998 +7954 2242 4 0 18.627063 -5.766281 -13.617980 +7955 2242 4 0 19.549944 -6.934441 -13.170231 +7956 2243 6 0 -27.003747 -19.268722 -9.708049 +7957 2243 4 0 -26.900925 -18.931745 -10.609127 +7958 2243 4 0 -27.848600 -18.948692 -9.403186 +7959 2244 6 0 25.990256 18.432601 -19.230300 +7960 2244 4 0 26.786890 18.827306 -19.540837 +7961 2244 4 0 25.720829 18.921009 -18.426769 +7962 2245 6 0 -23.820277 -18.817979 -12.740742 +7963 2245 4 0 -23.782285 -19.769046 -12.956748 +7964 2245 4 0 -23.248364 -18.334977 -13.329239 +7965 2246 6 0 -18.359691 4.931419 0.480080 +7966 2246 4 0 -18.326292 5.822977 0.895967 +7967 2246 4 0 -17.534355 4.919940 -0.130658 +7968 2247 6 0 -18.507249 20.994985 10.044481 +7969 2247 4 0 -18.547987 20.135365 9.607738 +7970 2247 4 0 -19.101082 20.989892 10.808237 +7971 2248 6 0 -4.383167 -16.727404 18.388451 +7972 2248 4 0 -5.073507 -17.158665 17.848255 +7973 2248 4 0 -3.547429 -16.962110 18.031186 +7974 2249 6 0 -4.804252 -2.255440 12.424858 +7975 2249 4 0 -5.246469 -3.100345 12.658891 +7976 2249 4 0 -3.913941 -2.453866 12.205563 +7977 2250 6 0 -24.450781 12.411164 4.813077 +7978 2250 4 0 -24.979534 11.582140 4.901976 +7979 2250 4 0 -24.028938 12.289668 3.990280 +7980 2251 6 0 -26.039273 15.478503 -20.033643 +7981 2251 4 0 -25.787380 14.593225 -19.599455 +7982 2251 4 0 -26.775794 15.819420 -19.491089 +7983 2252 6 0 14.062056 9.563642 16.993740 +7984 2252 4 0 14.763770 8.911350 17.143673 +7985 2252 4 0 14.500104 10.412012 17.077299 +7986 2253 6 0 4.484184 -11.730676 11.850201 +7987 2253 4 0 4.881439 -12.103947 12.684819 +7988 2253 4 0 3.547835 -11.668873 12.049225 +7989 2254 6 0 -14.097503 8.062860 -18.256877 +7990 2254 4 0 -14.097091 8.286015 -19.217701 +7991 2254 4 0 -14.272348 7.101844 -18.168430 +7992 2255 6 0 -1.242617 -6.859800 16.709128 +7993 2255 4 0 -1.538903 -6.069642 17.158826 +7994 2255 4 0 -0.956774 -6.520222 15.820973 +7995 2256 6 0 -1.281101 10.186382 20.363478 +7996 2256 4 0 -1.124991 9.953584 19.434999 +7997 2256 4 0 -1.916024 10.917360 20.415283 +7998 2257 6 0 4.583247 -14.837260 7.792526 +7999 2257 4 0 5.277242 -15.516956 7.802532 +8000 2257 4 0 3.716772 -15.158571 7.921129 +8001 2258 6 0 -4.482585 -19.369183 -19.767924 +8002 2258 4 0 -4.741173 -18.669761 -19.147665 +8003 2258 4 0 -4.193943 -19.053555 -20.619737 +8004 2259 6 0 7.047318 -14.707276 -20.284385 +8005 2259 4 0 6.703500 -15.207330 -19.488017 +8006 2259 4 0 6.190142 -14.503563 -20.700524 +8007 2260 6 0 23.833142 -6.861157 16.589067 +8008 2260 4 0 24.695476 -7.170817 16.950692 +8009 2260 4 0 23.677150 -7.301955 15.784807 +8010 2261 6 0 5.995679 -17.998909 3.914141 +8011 2261 4 0 5.476318 -17.882781 3.080567 +8012 2261 4 0 5.412579 -18.346872 4.640099 +8013 2262 6 0 -16.261535 -16.837503 19.128385 +8014 2262 4 0 -16.159495 -17.582113 18.531735 +8015 2262 4 0 -16.037295 -17.072210 20.047591 +8016 2263 6 0 12.975391 18.290335 10.617581 +8017 2263 4 0 12.118949 18.283115 10.175431 +8018 2263 4 0 12.802601 18.580055 11.511186 +8019 2264 6 0 -16.943334 -0.673380 -20.801827 +8020 2264 4 0 -17.817924 -1.087446 -20.715945 +8021 2264 4 0 -17.115465 0.133442 -21.270654 +8022 2265 6 0 6.976699 -19.049773 17.844693 +8023 2265 4 0 7.570702 -18.339339 17.660197 +8024 2265 4 0 7.315559 -19.860252 17.427987 +8025 2266 6 0 24.109467 19.393222 12.331621 +8026 2266 4 0 23.874527 19.733950 13.195341 +8027 2266 4 0 23.847585 18.486492 12.389872 +8028 2267 6 0 -10.766788 -13.469242 4.827464 +8029 2267 4 0 -10.709694 -13.795601 3.910452 +8030 2267 4 0 -10.845380 -12.510608 4.689270 +8031 2268 6 0 23.311349 8.299149 -20.488106 +8032 2268 4 0 22.936005 9.229209 -20.435353 +8033 2268 4 0 23.101181 8.056904 -21.396526 +8034 2269 6 0 14.346382 2.187727 18.536242 +8035 2269 4 0 14.267850 1.244178 18.689768 +8036 2269 4 0 15.244469 2.406046 18.304739 +8037 2270 6 0 -26.947566 -9.971921 -7.791553 +8038 2270 4 0 -26.523003 -9.588995 -7.018587 +8039 2270 4 0 -27.719947 -9.398867 -7.926452 +8040 2271 6 0 -1.645004 -17.217466 18.281848 +8041 2271 4 0 -1.503441 -17.212547 17.328466 +8042 2271 4 0 -1.259441 -16.407871 18.526419 +8043 2272 6 0 -18.185068 -13.481465 -18.963605 +8044 2272 4 0 -18.306998 -12.962840 -18.154768 +8045 2272 4 0 -18.826126 -14.192063 -18.983318 +8046 2273 6 0 21.894032 -11.323972 -14.426640 +8047 2273 4 0 22.165764 -10.897898 -13.607124 +8048 2273 4 0 22.549926 -11.213429 -15.092175 +8049 2274 6 0 10.286552 3.282899 -14.672865 +8050 2274 4 0 10.156644 2.736482 -13.881860 +8051 2274 4 0 9.503828 3.794923 -14.925645 +8052 2275 6 0 -17.275465 -16.899995 -12.204316 +8053 2275 4 0 -16.650047 -17.347498 -12.847925 +8054 2275 4 0 -17.728716 -17.694142 -11.839955 +8055 2276 6 0 9.132713 -17.465568 14.475104 +8056 2276 4 0 9.109121 -16.931937 13.716053 +8057 2276 4 0 8.685477 -18.260615 14.298118 +8058 2277 6 0 -2.219003 -10.437316 7.385585 +8059 2277 4 0 -2.683869 -9.726981 6.932036 +8060 2277 4 0 -2.863656 -10.910261 7.899378 +8061 2278 6 0 21.328627 5.452241 -5.411722 +8062 2278 4 0 20.702591 5.402774 -4.696060 +8063 2278 4 0 21.847512 4.616832 -5.258353 +8064 2279 6 0 25.174339 -4.700786 4.319189 +8065 2279 4 0 25.475426 -5.192515 3.516499 +8066 2279 4 0 24.849082 -5.290270 5.019481 +8067 2280 6 0 -20.973509 17.475850 18.235841 +8068 2280 4 0 -20.795645 16.959839 19.077904 +8069 2280 4 0 -21.937194 17.741268 18.405829 +8070 2281 6 0 -17.032214 -4.404070 -16.615581 +8071 2281 4 0 -18.027750 -4.237947 -16.713048 +8072 2281 4 0 -16.825738 -5.153522 -17.221012 +8073 2282 6 0 5.077355 4.864838 15.841740 +8074 2282 4 0 5.888380 4.293000 15.916342 +8075 2282 4 0 5.502771 5.719564 15.999661 +8076 2283 6 0 14.150746 7.193364 7.768856 +8077 2283 4 0 13.512887 7.556242 8.342946 +8078 2283 4 0 13.719519 6.964481 6.933299 +8079 2284 6 0 24.979967 10.864144 -3.827107 +8080 2284 4 0 25.315666 11.790605 -3.820018 +8081 2284 4 0 24.586117 10.647324 -4.635764 +8082 2285 6 0 -19.307013 7.977617 -19.097895 +8083 2285 4 0 -18.730894 8.713079 -18.873103 +8084 2285 4 0 -19.574094 8.132279 -20.016040 +8085 2286 6 0 24.806727 -12.761480 -19.492468 +8086 2286 4 0 24.884669 -13.553250 -18.933552 +8087 2286 4 0 23.868023 -12.741257 -19.679606 +8088 2287 6 0 -16.494024 -10.263681 -3.455262 +8089 2287 4 0 -16.433900 -9.520847 -4.087773 +8090 2287 4 0 -16.512097 -9.942519 -2.552121 +8091 2288 6 0 7.239107 -8.678420 15.402099 +8092 2288 4 0 8.128327 -8.620090 15.837696 +8093 2288 4 0 7.413730 -9.358400 14.729775 +8094 2289 6 0 -11.637039 -18.299602 1.445919 +8095 2289 4 0 -11.805502 -17.472273 0.974361 +8096 2289 4 0 -10.835652 -18.063314 1.950128 +8097 2290 6 0 3.539913 -9.008378 14.869684 +8098 2290 4 0 3.690725 -8.667083 13.987735 +8099 2290 4 0 3.786240 -8.275061 15.438308 +8100 2291 6 0 25.309639 -20.139973 8.261630 +8101 2291 4 0 26.025004 -20.789387 8.243372 +8102 2291 4 0 24.785538 -20.229959 9.088332 +8103 2292 6 0 -11.167618 15.368263 17.768795 +8104 2292 4 0 -11.447760 15.042536 16.890680 +8105 2292 4 0 -10.221576 15.243374 17.719247 +8106 2293 6 0 15.783799 16.252451 16.657327 +8107 2293 4 0 16.469650 16.826129 16.279349 +8108 2293 4 0 15.146657 16.166099 16.010457 +8109 2294 6 0 -23.087822 12.851874 11.524125 +8110 2294 4 0 -22.550515 13.272517 12.247361 +8111 2294 4 0 -23.433828 13.646077 11.045696 +8112 2295 6 0 18.224787 5.336233 10.181216 +8113 2295 4 0 17.768669 5.758936 9.423686 +8114 2295 4 0 17.527118 5.295554 10.828797 +8115 2296 6 0 23.091715 -2.832106 10.928215 +8116 2296 4 0 23.963022 -3.221214 10.847174 +8117 2296 4 0 23.111421 -1.957098 10.500452 +8118 2297 6 0 -8.122293 -8.153763 8.762475 +8119 2297 4 0 -8.486311 -7.377176 8.275878 +8120 2297 4 0 -7.842547 -7.967759 9.693098 +8121 2298 6 0 -23.746981 -1.978340 20.222446 +8122 2298 4 0 -24.119623 -2.610408 19.587105 +8123 2298 4 0 -22.788269 -2.052555 20.075719 +8124 2299 6 0 15.889034 -8.818090 19.786354 +8125 2299 4 0 16.162821 -8.087882 19.189549 +8126 2299 4 0 16.517604 -9.567302 19.583898 +8127 2300 6 0 -22.434542 -1.993577 2.665229 +8128 2300 4 0 -21.639169 -2.320398 3.125908 +8129 2300 4 0 -22.887302 -1.544538 3.368374 +8130 2301 6 0 -4.294135 12.198286 3.905187 +8131 2301 4 0 -3.524217 12.481373 3.400532 +8132 2301 4 0 -4.358032 12.831366 4.583192 +8133 2302 6 0 -10.287802 2.763656 12.120543 +8134 2302 4 0 -10.140580 1.873404 11.826731 +8135 2302 4 0 -10.262187 2.731368 13.100818 +8136 2303 6 0 11.514142 11.933521 -10.265166 +8137 2303 4 0 11.257715 12.740478 -9.772518 +8138 2303 4 0 11.449563 11.209135 -9.611780 +8139 2304 6 0 4.752686 10.041816 10.494911 +8140 2304 4 0 5.000099 10.228340 11.405783 +8141 2304 4 0 4.465587 10.901799 10.118351 +8142 2305 6 0 17.099352 -16.900118 20.580015 +8143 2305 4 0 16.248341 -17.056394 20.914403 +8144 2305 4 0 16.964732 -16.230792 19.853524 +8145 2306 6 0 -6.880763 4.754709 14.803663 +8146 2306 4 0 -7.780049 5.017298 14.837120 +8147 2306 4 0 -6.602000 5.380408 14.109963 +8148 2307 6 0 18.852257 3.117416 3.416315 +8149 2307 4 0 18.466519 2.248205 3.599368 +8150 2307 4 0 19.770424 2.988919 3.600584 +8151 2308 6 0 -19.565302 -15.452338 -12.857316 +8152 2308 4 0 -19.465174 -14.703294 -13.434992 +8153 2308 4 0 -18.713185 -15.861077 -12.849765 +8154 2309 6 0 -22.600437 -10.691469 12.850297 +8155 2309 4 0 -23.397550 -10.659087 13.302216 +8156 2309 4 0 -22.787116 -11.067370 12.012734 +8157 2310 6 0 -21.982415 -13.573385 -4.311729 +8158 2310 4 0 -22.884778 -13.924822 -4.053153 +8159 2310 4 0 -21.591210 -13.340585 -3.436663 +8160 2311 6 0 -9.482768 -17.119153 10.316888 +8161 2311 4 0 -10.089752 -16.593034 9.704444 +8162 2311 4 0 -9.402425 -17.912940 9.854825 +8163 2312 6 0 14.779023 -10.205617 3.169184 +8164 2312 4 0 14.033719 -9.624095 2.903870 +8165 2312 4 0 14.431082 -10.650018 3.996000 +8166 2313 6 0 -23.065785 7.688851 4.302863 +8167 2313 4 0 -23.519497 6.846326 4.179947 +8168 2313 4 0 -23.396856 8.243234 3.642471 +8169 2314 6 0 -12.420110 17.313613 -9.713155 +8170 2314 4 0 -13.364634 17.232909 -9.649724 +8171 2314 4 0 -12.198343 18.200726 -10.087577 +8172 2315 6 0 13.807063 -18.735375 -18.358481 +8173 2315 4 0 13.518261 -18.146104 -17.665040 +8174 2315 4 0 14.609291 -19.207101 -18.003404 +8175 2316 6 0 10.712591 7.098327 3.970951 +8176 2316 4 0 10.424496 6.939336 4.829144 +8177 2316 4 0 10.486897 6.231102 3.501449 +8178 2317 6 0 -26.193278 8.679696 17.901485 +8179 2317 4 0 -25.410504 8.357458 17.457879 +8180 2317 4 0 -26.819464 8.901614 17.137834 +8181 2318 6 0 19.451507 -12.567707 -15.280479 +8182 2318 4 0 19.003766 -12.254527 -14.428024 +8183 2318 4 0 20.294592 -12.135913 -15.254851 +8184 2319 6 0 -14.332854 -0.923507 14.572189 +8185 2319 4 0 -14.044747 -0.194105 14.037975 +8186 2319 4 0 -13.492568 -1.193300 14.988120 +8187 2320 6 0 -8.730522 14.085678 -10.180676 +8188 2320 4 0 -8.524068 13.138626 -10.211460 +8189 2320 4 0 -9.480763 14.191583 -10.748692 +8190 2321 6 0 -18.278878 -5.590157 8.386336 +8191 2321 4 0 -18.405152 -4.662040 8.661744 +8192 2321 4 0 -17.563780 -5.717750 9.039776 +8193 2322 6 0 -24.210906 -9.471833 -3.828648 +8194 2322 4 0 -23.595084 -9.970587 -4.330527 +8195 2322 4 0 -23.577826 -8.951405 -3.327851 +8196 2323 6 0 -7.110604 8.838398 10.174602 +8197 2323 4 0 -7.782545 9.119070 9.563121 +8198 2323 4 0 -6.874836 7.936950 10.110612 +8199 2324 6 0 24.419141 17.000522 -10.922840 +8200 2324 4 0 23.664703 16.933938 -11.553390 +8201 2324 4 0 24.021846 17.152778 -10.052143 +8202 2325 6 0 -14.488243 5.098469 4.479912 +8203 2325 4 0 -13.709956 5.650481 4.473177 +8204 2325 4 0 -14.910202 5.058380 3.581039 +8205 2326 6 0 -2.415807 -13.812743 6.907700 +8206 2326 4 0 -2.596718 -13.309899 6.111317 +8207 2326 4 0 -3.251745 -14.327682 7.109165 +8208 2327 6 0 -18.926033 -9.523396 -18.297588 +8209 2327 4 0 -18.539154 -9.705366 -19.167443 +8210 2327 4 0 -19.196583 -8.616444 -18.314206 +8211 2328 6 0 23.648770 -10.033565 -19.143545 +8212 2328 4 0 23.763359 -9.374241 -19.822180 +8213 2328 4 0 24.359914 -10.609348 -19.397407 +8214 2329 6 0 0.735457 -17.444252 -0.196869 +8215 2329 4 0 1.204966 -17.103235 -0.982724 +8216 2329 4 0 -0.166461 -17.675326 -0.501142 +8217 2330 6 0 15.977053 8.980217 19.819118 +8218 2330 4 0 15.510910 8.262919 19.411773 +8219 2330 4 0 15.638831 9.774710 19.469638 +8220 2331 6 0 -21.818391 12.562887 20.032627 +8221 2331 4 0 -22.085628 11.618258 19.842948 +8222 2331 4 0 -20.827992 12.718524 19.975012 +8223 2332 6 0 7.039712 -16.964990 -15.541675 +8224 2332 4 0 6.809451 -17.534371 -14.799854 +8225 2332 4 0 7.846558 -16.584905 -15.213738 +8226 2333 6 0 -10.516103 -19.359216 -4.984483 +8227 2333 4 0 -11.487322 -19.499249 -4.976576 +8228 2333 4 0 -10.316797 -19.130113 -5.876399 +8229 2334 6 0 -15.712544 -18.195821 -16.791463 +8230 2334 4 0 -15.386725 -17.379305 -16.972966 +8231 2334 4 0 -16.234052 -18.450302 -17.577749 +8232 2335 6 0 20.375630 2.207122 -4.920313 +8233 2335 4 0 20.216775 1.456591 -4.343459 +8234 2335 4 0 20.280207 1.853389 -5.797632 +8235 2336 6 0 22.857055 19.552693 3.665905 +8236 2336 4 0 22.878248 19.783393 4.649190 +8237 2336 4 0 23.742572 19.802123 3.384761 +8238 2337 6 0 -23.291098 12.571857 -7.317143 +8239 2337 4 0 -23.912608 13.233941 -6.880268 +8240 2337 4 0 -22.652186 12.332429 -6.543330 +8241 2338 6 0 12.984606 10.221427 -16.808099 +8242 2338 4 0 13.667678 9.959368 -16.244780 +8243 2338 4 0 12.511584 9.401797 -16.883576 +8244 2339 6 0 27.270245 0.587979 13.208753 +8245 2339 4 0 27.702404 -0.278797 13.294250 +8246 2339 4 0 26.279511 0.464606 13.258979 +8247 2340 6 0 5.657499 -16.976293 13.990530 +8248 2340 4 0 4.705984 -16.954734 13.883042 +8249 2340 4 0 5.909722 -16.502798 14.791441 +8250 2341 6 0 22.979947 17.951763 0.527007 +8251 2341 4 0 22.428004 18.639190 0.176667 +8252 2341 4 0 22.281623 17.341478 0.914453 +8253 2342 6 0 -21.891524 -16.491873 5.462047 +8254 2342 4 0 -21.611111 -15.606060 5.550776 +8255 2342 4 0 -22.025511 -16.701806 4.529568 +8256 2343 6 0 8.528721 7.946876 17.483315 +8257 2343 4 0 9.390982 8.385502 17.311853 +8258 2343 4 0 8.485801 7.948173 18.426233 +8259 2344 6 0 26.823691 0.686378 2.887481 +8260 2344 4 0 26.841167 0.391628 3.805678 +8261 2344 4 0 26.597454 1.662650 2.917193 +8262 2345 6 0 -4.950286 -7.194323 15.626699 +8263 2345 4 0 -4.352839 -6.657887 15.072055 +8264 2345 4 0 -5.857741 -7.272638 15.219003 +8265 2346 6 0 -8.714977 5.000352 11.128210 +8266 2346 4 0 -9.170865 4.207326 11.391243 +8267 2346 4 0 -8.026665 4.716136 10.523111 +8268 2347 6 0 -21.206733 -3.279994 -6.524932 +8269 2347 4 0 -20.929590 -2.947470 -5.608742 +8270 2347 4 0 -21.369929 -2.564467 -7.124044 +8271 2348 6 0 -24.169876 -16.066494 -0.699927 +8272 2348 4 0 -23.893194 -16.983386 -0.501792 +8273 2348 4 0 -23.818535 -15.566437 0.016995 +8274 2349 6 0 -4.762418 0.978128 -17.450230 +8275 2349 4 0 -5.459419 0.534407 -17.851461 +8276 2349 4 0 -3.876584 0.532188 -17.586085 +8277 2350 6 0 -23.690384 0.720873 19.030161 +8278 2350 4 0 -24.529537 0.743437 18.583662 +8279 2350 4 0 -23.655688 -0.011267 19.593259 +8280 2351 6 0 -15.912159 -12.362138 19.142289 +8281 2351 4 0 -16.860673 -12.328378 19.455109 +8282 2351 4 0 -15.543971 -13.259386 19.298591 +8283 2352 6 0 21.658993 17.599149 -16.014662 +8284 2352 4 0 22.041785 18.520354 -15.943036 +8285 2352 4 0 20.778035 17.749200 -16.427622 +8286 2353 6 0 -19.912308 -13.107035 -14.484614 +8287 2353 4 0 -19.659870 -12.430860 -13.832450 +8288 2353 4 0 -19.896529 -12.695904 -15.325705 +8289 2354 6 0 -24.276277 -16.465070 11.658834 +8290 2354 4 0 -24.414709 -16.008322 12.561598 +8291 2354 4 0 -24.456920 -15.764788 11.022016 +8292 2355 6 0 7.338121 15.134359 12.353797 +8293 2355 4 0 6.756929 14.359360 12.209000 +8294 2355 4 0 7.312954 15.621960 11.560650 +8295 2356 6 0 16.833359 -15.091185 7.049718 +8296 2356 4 0 17.575828 -15.201998 7.598156 +8297 2356 4 0 17.181929 -14.913423 6.159696 +8298 2357 6 0 -25.459827 -8.831619 -10.909942 +8299 2357 4 0 -26.346699 -9.154571 -11.164077 +8300 2357 4 0 -25.113612 -9.635356 -10.548749 +8301 2358 6 0 14.104756 2.118788 -11.000106 +8302 2358 4 0 14.145828 1.958779 -9.996196 +8303 2358 4 0 13.664160 1.315915 -11.343904 +8304 2359 6 0 15.657145 -19.646810 2.896166 +8305 2359 4 0 16.434824 -20.115913 3.051182 +8306 2359 4 0 15.028606 -20.220332 2.452201 +8307 2360 6 0 23.725885 -12.794695 -0.945499 +8308 2360 4 0 23.281780 -11.890719 -0.926868 +8309 2360 4 0 24.708749 -12.621299 -0.988388 +8310 2361 6 0 -16.865263 14.164216 13.710722 +8311 2361 4 0 -17.362193 13.380801 13.838272 +8312 2361 4 0 -16.087062 13.922374 13.209541 +8313 2362 6 0 -19.739666 -15.403180 15.520974 +8314 2362 4 0 -20.455057 -15.397351 14.881774 +8315 2362 4 0 -20.082522 -14.871806 16.282279 +8316 2363 6 0 19.096837 -7.172079 16.486018 +8317 2363 4 0 19.407501 -6.257692 16.370379 +8318 2363 4 0 19.040095 -7.459208 15.607247 +8319 2364 6 0 18.172332 -12.158590 -6.201699 +8320 2364 4 0 18.304057 -11.335714 -6.732706 +8321 2364 4 0 19.035089 -12.338188 -5.764950 +8322 2365 6 0 -0.868698 -19.642469 -16.996885 +8323 2365 4 0 -1.363468 -20.113317 -17.713302 +8324 2365 4 0 -1.471726 -19.010491 -16.662422 +8325 2366 6 0 -24.645397 10.341459 -7.907386 +8326 2366 4 0 -25.403222 10.434913 -7.336084 +8327 2366 4 0 -24.138877 11.164300 -7.816681 +8328 2367 6 0 -16.672238 -8.013464 18.598945 +8329 2367 4 0 -16.066967 -8.743970 18.706313 +8330 2367 4 0 -16.176282 -7.259661 18.335226 +8331 2368 6 0 22.487322 14.165266 -7.478753 +8332 2368 4 0 22.557098 13.462620 -8.195467 +8333 2368 4 0 23.077183 13.896514 -6.804199 +8334 2369 6 0 -16.969008 0.617904 2.364611 +8335 2369 4 0 -17.366120 1.196458 3.012496 +8336 2369 4 0 -16.204897 0.132723 2.713670 +8337 2370 6 0 -16.105014 -0.776954 10.291984 +8338 2370 4 0 -16.257341 0.223589 10.333435 +8339 2370 4 0 -16.822249 -1.143779 10.739482 +8340 2371 6 0 -1.572980 -19.983373 -2.947973 +8341 2371 4 0 -1.992560 -20.034455 -3.807433 +8342 2371 4 0 -0.620010 -19.746082 -3.116100 +8343 2372 6 0 -14.996679 12.712532 -5.614114 +8344 2372 4 0 -15.916609 12.454215 -5.655277 +8345 2372 4 0 -14.599913 12.087283 -6.181656 +8346 2373 6 0 -6.550042 17.243085 -1.311911 +8347 2373 4 0 -7.370137 17.795578 -1.470109 +8348 2373 4 0 -6.675338 16.814239 -0.435288 +8349 2374 6 0 -22.961585 9.343900 -1.894881 +8350 2374 4 0 -22.135413 9.413165 -2.387021 +8351 2374 4 0 -23.019360 8.393337 -1.628379 +8352 2375 6 0 -23.240008 -19.417092 6.368497 +8353 2375 4 0 -23.612098 -20.201035 6.825569 +8354 2375 4 0 -23.684109 -18.690648 6.877699 +8355 2376 6 0 -3.975590 2.585287 -20.330975 +8356 2376 4 0 -3.555653 1.727030 -20.090182 +8357 2376 4 0 -3.232879 3.201768 -20.459323 +8358 2377 6 0 13.624748 -19.863473 12.144241 +8359 2377 4 0 14.457772 -19.530528 12.546517 +8360 2377 4 0 12.915028 -19.260602 12.383266 +8361 2378 6 0 23.620886 -17.871879 14.645268 +8362 2378 4 0 24.200914 -17.421417 15.259794 +8363 2378 4 0 23.549736 -17.298378 13.830439 +8364 2379 6 0 9.321358 4.851563 -10.671349 +8365 2379 4 0 8.417643 4.825903 -10.980879 +8366 2379 4 0 9.236659 5.389642 -9.880988 +8367 2380 6 0 16.676932 -15.595371 18.042582 +8368 2380 4 0 15.776328 -15.312249 17.740520 +8369 2380 4 0 17.268778 -14.856833 17.976717 +8370 2381 6 0 5.120016 13.517889 11.545409 +8371 2381 4 0 4.343182 13.415911 12.098245 +8372 2381 4 0 4.693345 13.853732 10.680472 +8373 2382 6 0 -25.377039 -18.256471 8.076220 +8374 2382 4 0 -25.781276 -18.544454 8.897977 +8375 2382 4 0 -25.633977 -17.323858 7.972468 +8376 2383 6 0 0.809058 7.564416 -14.066874 +8377 2383 4 0 0.916059 7.331613 -13.143223 +8378 2383 4 0 1.470333 8.274989 -14.200531 +8379 2384 6 0 15.418267 9.781452 0.490529 +8380 2384 4 0 16.087047 9.430117 -0.107289 +8381 2384 4 0 15.469266 9.208927 1.264230 +8382 2385 6 0 18.819099 0.059487 -7.791298 +8383 2385 4 0 18.409799 -0.334456 -8.599701 +8384 2385 4 0 18.505418 0.975155 -7.815461 +8385 2386 6 0 18.734857 -11.129665 -12.743525 +8386 2386 4 0 19.553404 -11.223386 -12.120138 +8387 2386 4 0 18.518443 -10.240054 -12.855533 +8388 2387 6 0 -6.542631 16.490309 -5.774007 +8389 2387 4 0 -7.424909 16.908246 -5.691889 +8390 2387 4 0 -6.518994 16.127379 -6.676862 +8391 2388 6 0 -11.192140 0.472205 -12.639446 +8392 2388 4 0 -12.103697 0.267919 -12.529950 +8393 2388 4 0 -10.710800 -0.374282 -12.557572 +8394 2389 6 0 16.720488 13.886958 -20.533060 +8395 2389 4 0 16.205223 14.702224 -20.376437 +8396 2389 4 0 16.691127 13.403715 -19.702754 +8397 2390 6 0 17.388334 13.435587 -15.657568 +8398 2390 4 0 18.130270 13.582226 -16.327461 +8399 2390 4 0 17.639406 12.621568 -15.195169 +8400 2391 6 0 -6.834253 10.232886 -18.214238 +8401 2391 4 0 -6.903061 10.582756 -17.312839 +8402 2391 4 0 -7.065760 10.977380 -18.753726 +8403 2392 6 0 -26.724908 17.912645 17.886470 +8404 2392 4 0 -25.957218 18.458136 17.628812 +8405 2392 4 0 -26.362765 17.099535 18.218344 +8406 2393 6 0 -0.903403 -3.732795 -18.221524 +8407 2393 4 0 0.015845 -3.986413 -18.434069 +8408 2393 4 0 -1.449749 -4.292278 -18.787390 +8409 2394 6 0 8.478846 18.397280 11.407292 +8410 2394 4 0 7.633351 18.651942 11.041557 +8411 2394 4 0 9.129265 18.582960 10.779627 +8412 2395 6 0 -9.044898 12.879599 11.037060 +8413 2395 4 0 -8.299458 12.613036 10.480728 +8414 2395 4 0 -9.785562 12.774996 10.383091 +8415 2396 6 0 16.212680 8.794036 14.029672 +8416 2396 4 0 15.473945 9.288728 13.836685 +8417 2396 4 0 17.028607 9.276518 14.011973 +8418 2397 6 0 -12.268552 13.361223 -20.521861 +8419 2397 4 0 -13.186409 13.158881 -20.579852 +8420 2397 4 0 -12.306685 14.297827 -20.782380 +8421 2398 6 0 21.001802 -1.484392 16.467423 +8422 2398 4 0 20.737187 -1.861020 17.327615 +8423 2398 4 0 21.860569 -1.911455 16.193850 +8424 2399 6 0 -9.356304 11.431280 -8.974418 +8425 2399 4 0 -8.659737 10.769575 -8.653703 +8426 2399 4 0 -9.803431 11.675976 -8.182315 +8427 2400 6 0 26.948445 8.871461 -17.613543 +8428 2400 4 0 27.531052 9.681414 -17.576254 +8429 2400 4 0 27.482335 8.261182 -17.042391 +8430 2401 6 0 18.976966 2.434133 -12.543728 +8431 2401 4 0 18.194377 2.424795 -11.982928 +8432 2401 4 0 19.117316 3.368724 -12.808991 +8433 2402 6 0 8.245403 -12.742057 19.723005 +8434 2402 4 0 8.144484 -13.022949 20.662655 +8435 2402 4 0 7.837153 -13.446042 19.196869 +8436 2403 6 0 9.039756 -7.597109 18.653269 +8437 2403 4 0 8.770812 -7.616934 19.576989 +8438 2403 4 0 9.066589 -6.664479 18.418706 +8439 2404 6 0 10.189217 11.926636 11.235547 +8440 2404 4 0 10.233257 12.873995 11.065027 +8441 2404 4 0 9.236322 11.798256 11.121031 +8442 2405 6 0 -19.235380 -20.224186 -5.743147 +8443 2405 4 0 -19.963520 -19.550478 -5.766714 +8444 2405 4 0 -18.597575 -19.892671 -5.077870 +8445 2406 6 0 17.081164 12.504780 -5.519702 +8446 2406 4 0 17.317528 12.830762 -4.628825 +8447 2406 4 0 17.566228 11.707478 -5.694496 +8448 2407 6 0 -17.833354 13.022736 -7.625662 +8449 2407 4 0 -18.435075 12.266236 -7.562794 +8450 2407 4 0 -17.596760 13.126821 -6.753333 +8451 2408 6 0 -16.003848 -12.359888 13.230149 +8452 2408 4 0 -16.195567 -13.201470 12.841886 +8453 2408 4 0 -16.339851 -12.416796 14.117412 +8454 2409 6 0 0.176516 -12.560501 -12.425472 +8455 2409 4 0 0.737394 -13.294947 -12.707192 +8456 2409 4 0 -0.008554 -11.988851 -13.210535 +8457 2410 6 0 15.945838 0.256833 12.759642 +8458 2410 4 0 15.315992 0.578271 12.079867 +8459 2410 4 0 15.303877 -0.130234 13.393857 +8460 2411 6 0 3.991270 11.948196 8.788506 +8461 2411 4 0 4.354131 11.617913 7.978688 +8462 2411 4 0 3.989725 12.878797 8.755522 +8463 2412 6 0 24.041021 -18.227784 19.978317 +8464 2412 4 0 23.613150 -19.023367 19.715938 +8465 2412 4 0 23.421760 -17.634320 20.391706 +8466 2413 6 0 4.480569 2.293232 -17.929461 +8467 2413 4 0 4.737918 2.408019 -18.806644 +8468 2413 4 0 3.697109 2.859289 -17.719771 +8469 2414 6 0 -21.893430 -14.247042 -8.071389 +8470 2414 4 0 -21.621325 -13.340615 -8.179140 +8471 2414 4 0 -21.245096 -14.771492 -7.611926 +8472 2415 6 0 11.391170 -20.197067 6.087190 +8473 2415 4 0 12.332346 -20.225253 6.056925 +8474 2415 4 0 11.169435 -19.741912 5.268989 +8475 2416 6 0 -17.767521 13.536365 -18.283934 +8476 2416 4 0 -17.676219 14.086222 -17.468766 +8477 2416 4 0 -17.016627 12.978563 -18.394451 +8478 2417 6 0 5.005032 -20.873389 -8.545316 +8479 2417 4 0 4.212566 -20.486316 -8.983260 +8480 2417 4 0 4.690972 -21.402526 -7.849785 +8481 2418 6 0 18.199775 -4.330757 -14.972084 +8482 2418 4 0 17.789625 -3.483346 -14.772916 +8483 2418 4 0 18.849294 -4.135351 -15.681645 +8484 2419 6 0 19.744670 16.153747 4.684702 +8485 2419 4 0 18.926975 15.872879 5.113981 +8486 2419 4 0 20.486481 15.836577 5.222155 +8487 2420 6 0 -0.915970 -9.397508 15.585411 +8488 2420 4 0 -0.105843 -9.703483 16.010408 +8489 2420 4 0 -1.285330 -8.812368 16.200287 +8490 2421 6 0 -23.858596 3.816844 -5.177897 +8491 2421 4 0 -23.879687 4.029482 -4.237763 +8492 2421 4 0 -24.276504 2.954820 -5.342696 +8493 2422 6 0 11.838596 14.359137 5.947499 +8494 2422 4 0 11.923450 13.438110 5.725008 +8495 2422 4 0 12.426438 14.419837 6.789373 +8496 2423 6 0 -24.516087 -8.212903 6.467548 +8497 2423 4 0 -24.905939 -8.825058 7.092971 +8498 2423 4 0 -23.896260 -8.737352 6.010203 +8499 2424 6 0 12.794509 0.536645 -20.243875 +8500 2424 4 0 12.046024 0.975194 -20.739130 +8501 2424 4 0 12.750658 0.998686 -19.404096 +8502 2425 6 0 -2.221545 7.221132 -15.714309 +8503 2425 4 0 -1.564134 7.922819 -15.440249 +8504 2425 4 0 -1.907716 6.786282 -16.499729 +8505 2426 6 0 -15.262103 -1.025135 3.744497 +8506 2426 4 0 -15.665604 -1.870757 3.765630 +8507 2426 4 0 -15.328619 -0.606155 4.583614 +8508 2427 6 0 20.108494 -9.991193 -19.911625 +8509 2427 4 0 19.428700 -9.825766 -19.213627 +8510 2427 4 0 20.361712 -9.133136 -20.249113 +8511 2428 6 0 12.867409 -6.904802 4.443594 +8512 2428 4 0 12.264306 -6.203776 4.409753 +8513 2428 4 0 13.784027 -6.565705 4.350727 +8514 2429 6 0 24.058876 -8.248822 -17.051222 +8515 2429 4 0 23.730319 -9.008822 -17.519701 +8516 2429 4 0 24.878618 -8.026208 -17.519719 +8517 2430 6 0 -14.847363 -1.001783 -19.170682 +8518 2430 4 0 -15.449801 -0.826718 -19.858698 +8519 2430 4 0 -15.320403 -1.330455 -18.387373 +8520 2431 6 0 15.553192 2.814264 -3.465226 +8521 2431 4 0 14.896744 3.481739 -3.135135 +8522 2431 4 0 16.160657 3.336721 -3.991437 +8523 2432 6 0 -13.974002 9.185648 16.956055 +8524 2432 4 0 -13.130305 8.696408 16.805351 +8525 2432 4 0 -14.376866 8.733537 17.688722 +8526 2433 6 0 -11.797740 -0.516894 9.586967 +8527 2433 4 0 -12.628798 -0.925501 9.242559 +8528 2433 4 0 -11.646717 0.185675 8.970795 +8529 2434 6 0 24.903028 -3.994226 -11.118622 +8530 2434 4 0 23.952025 -4.106045 -10.736954 +8531 2434 4 0 24.790476 -3.484811 -11.918719 +8532 2435 6 0 2.220549 5.328975 16.431794 +8533 2435 4 0 1.808604 4.568086 16.851941 +8534 2435 4 0 3.174924 5.179737 16.323538 +8535 2436 6 0 1.396616 14.937103 19.138615 +8536 2436 4 0 0.558182 14.600636 18.844822 +8537 2436 4 0 1.257435 14.884393 20.102246 +8538 2437 6 0 -20.671636 -15.366474 -18.208204 +8539 2437 4 0 -21.380399 -15.277369 -18.859413 +8540 2437 4 0 -20.736983 -16.181001 -17.742657 +8541 2438 6 0 -13.058044 -20.095582 -4.362430 +8542 2438 4 0 -13.024712 -20.612656 -3.543798 +8543 2438 4 0 -13.691481 -19.389144 -4.075579 +8544 2439 6 0 -15.561123 -4.237765 12.636329 +8545 2439 4 0 -16.268647 -3.833291 13.167415 +8546 2439 4 0 -15.110937 -3.419743 12.299589 +8547 2440 6 0 -24.759181 -6.035582 2.884287 +8548 2440 4 0 -25.250513 -6.831996 2.887098 +8549 2440 4 0 -25.305365 -5.369041 2.551951 +8550 2441 6 0 -4.620853 12.299627 11.037908 +8551 2441 4 0 -4.440765 13.138122 11.409774 +8552 2441 4 0 -4.916886 11.692935 11.716163 +8553 2442 6 0 -16.569703 1.526861 -7.254759 +8554 2442 4 0 -16.695783 1.936301 -8.074606 +8555 2442 4 0 -16.882141 0.632206 -7.402201 +8556 2443 6 0 23.467888 -9.654261 -12.695108 +8557 2443 4 0 24.029597 -9.067666 -13.167615 +8558 2443 4 0 23.123232 -9.217050 -11.833851 +8559 2444 6 0 -18.429010 -3.061156 8.894173 +8560 2444 4 0 -19.027972 -2.389846 8.642550 +8561 2444 4 0 -18.106797 -2.785618 9.787642 +8562 2445 6 0 -19.107978 15.849121 -9.475466 +8563 2445 4 0 -18.864733 15.428418 -8.655322 +8564 2445 4 0 -18.505127 16.629956 -9.591908 +8565 2446 6 0 22.274682 -20.084251 -0.325198 +8566 2446 4 0 22.135094 -19.096797 -0.356152 +8567 2446 4 0 23.083213 -20.126631 -0.830959 +8568 2447 6 0 24.369325 -3.216706 -4.897640 +8569 2447 4 0 25.222404 -2.719894 -4.895318 +8570 2447 4 0 24.445157 -3.895914 -4.229474 +8571 2448 6 0 -9.139981 -19.842644 16.043544 +8572 2448 4 0 -8.820691 -19.672535 15.122253 +8573 2448 4 0 -9.672340 -20.660357 15.944536 +8574 2449 6 0 -20.896241 -15.764905 -2.307185 +8575 2449 4 0 -21.812479 -15.705631 -2.446120 +8576 2449 4 0 -20.844603 -15.784793 -1.327016 +8577 2450 6 0 7.223156 -5.748983 -18.629737 +8578 2450 4 0 7.206095 -4.844227 -18.946828 +8579 2450 4 0 7.989785 -5.796585 -18.164482 +8580 2451 6 0 -25.843140 -1.143611 9.149078 +8581 2451 4 0 -25.886005 -1.657786 8.289135 +8582 2451 4 0 -25.272098 -1.801443 9.596520 +8583 2452 6 0 -25.617505 11.234770 1.302402 +8584 2452 4 0 -26.519698 11.382080 0.891273 +8585 2452 4 0 -25.709717 11.496799 2.260967 +8586 2453 6 0 -24.008718 3.700426 14.077463 +8587 2453 4 0 -23.636744 2.818441 14.397144 +8588 2453 4 0 -24.193959 3.715212 13.098008 +8589 2454 6 0 -25.288161 15.287096 -3.633466 +8590 2454 4 0 -24.701801 15.181375 -2.917528 +8591 2454 4 0 -24.884059 15.980496 -4.222265 +8592 2455 6 0 -18.371976 0.316233 -12.753606 +8593 2455 4 0 -17.540257 0.805382 -12.677195 +8594 2455 4 0 -18.928928 0.935156 -13.269213 +8595 2456 6 0 -7.333443 0.117823 -18.660950 +8596 2456 4 0 -8.021021 0.414744 -18.077567 +8597 2456 4 0 -7.588161 -0.774648 -18.860400 +8598 2457 6 0 7.916046 -4.737118 -11.962175 +8599 2457 4 0 7.823803 -4.591176 -10.961540 +8600 2457 4 0 8.487079 -3.962811 -12.242330 +8601 2458 6 0 -16.065017 -17.683748 12.637430 +8602 2458 4 0 -17.011987 -17.735296 12.722608 +8603 2458 4 0 -15.831448 -18.384474 11.953837 +8604 2459 6 0 21.305339 -15.655490 -5.124093 +8605 2459 4 0 20.807407 -16.186834 -5.710639 +8606 2459 4 0 21.624819 -16.214868 -4.447516 +8607 2460 6 0 -26.764181 -18.581640 -16.921151 +8608 2460 4 0 -26.740653 -17.883931 -16.251171 +8609 2460 4 0 -25.889831 -19.016845 -16.852743 +8610 2461 6 0 -16.578359 -2.340901 14.589648 +8611 2461 4 0 -16.492161 -3.040832 15.326073 +8612 2461 4 0 -15.697628 -1.820257 14.616293 +8613 2462 6 0 26.043166 5.997514 -3.795215 +8614 2462 4 0 26.451990 6.864435 -3.803447 +8615 2462 4 0 26.795850 5.513156 -3.370169 +8616 2463 6 0 -2.866251 17.249672 -19.402655 +8617 2463 4 0 -2.050135 17.665045 -19.652864 +8618 2463 4 0 -2.832242 16.313071 -19.542218 +8619 2464 6 0 -15.459807 -11.710100 -10.460216 +8620 2464 4 0 -14.969300 -11.366276 -9.661631 +8621 2464 4 0 -16.276955 -12.017208 -9.984012 +8622 2465 6 0 19.650264 6.930828 12.762298 +8623 2465 4 0 19.873188 6.462285 13.595929 +8624 2465 4 0 20.303044 6.550090 12.177619 +8625 2466 6 0 -22.570365 -4.412836 -1.811273 +8626 2466 4 0 -22.171357 -5.263031 -1.838077 +8627 2466 4 0 -22.826216 -4.391044 -0.929643 +8628 2467 6 0 -15.225393 0.344956 6.093949 +8629 2467 4 0 -14.897061 1.256657 6.050627 +8630 2467 4 0 -14.862108 -0.118094 6.882677 +8631 2468 6 0 -26.214592 10.149434 -12.755279 +8632 2468 4 0 -27.155901 10.181440 -12.954282 +8633 2468 4 0 -26.080437 9.913123 -11.832638 +8634 2469 6 0 -26.639137 -20.836220 10.642324 +8635 2469 4 0 -26.244776 -19.942202 10.604043 +8636 2469 4 0 -26.010374 -21.363114 10.100802 +8637 2470 6 0 27.068918 -13.224704 20.865450 +8638 2470 4 0 27.744233 -12.679284 21.316162 +8639 2470 4 0 26.232445 -12.945570 21.191563 +8640 2471 6 0 -15.301597 13.975513 -8.460131 +8641 2471 4 0 -14.952706 13.782668 -7.567357 +8642 2471 4 0 -16.244257 13.821878 -8.381549 +8643 2472 6 0 25.467875 11.658105 -7.593959 +8644 2472 4 0 24.761290 11.160502 -7.120317 +8645 2472 4 0 25.002961 12.057880 -8.288551 +8646 2473 6 0 -27.479869 -4.262964 -20.483737 +8647 2473 4 0 -26.752473 -4.746654 -20.858210 +8648 2473 4 0 -27.165915 -3.756567 -19.782830 +8649 2474 6 0 -24.406173 20.048905 -13.265390 +8650 2474 4 0 -23.845919 19.394517 -12.782711 +8651 2474 4 0 -25.326791 19.952777 -13.266139 +8652 2475 6 0 -12.606740 1.855396 14.924299 +8653 2475 4 0 -13.099296 2.292250 15.633985 +8654 2475 4 0 -13.213129 1.841828 14.213081 +8655 2476 6 0 12.163259 12.537713 19.532478 +8656 2476 4 0 12.952113 12.023699 19.336851 +8657 2476 4 0 11.421932 11.885251 19.451751 +8658 2477 6 0 19.216013 1.204159 16.354062 +8659 2477 4 0 19.693651 0.628292 16.987922 +8660 2477 4 0 19.788924 1.982359 16.259421 +8661 2478 6 0 9.476954 16.143883 -14.222672 +8662 2478 4 0 9.874109 15.966920 -15.122506 +8663 2478 4 0 9.278436 15.281894 -13.908079 +8664 2479 6 0 -14.534233 -15.722743 -17.125213 +8665 2479 4 0 -14.612818 -15.234699 -16.271855 +8666 2479 4 0 -14.914996 -15.225762 -17.899753 +8667 2480 6 0 -7.315791 17.649326 18.027047 +8668 2480 4 0 -6.781097 18.032306 18.752166 +8669 2480 4 0 -8.151176 18.220094 17.921736 +8670 2481 6 0 -18.382710 -16.629801 4.193883 +8671 2481 4 0 -18.385951 -16.521263 5.149432 +8672 2481 4 0 -17.627253 -16.147937 3.769420 +8673 2482 6 0 -15.417927 -6.534956 -12.241821 +8674 2482 4 0 -15.990818 -7.277530 -12.157190 +8675 2482 4 0 -15.651097 -5.969923 -11.493776 +8676 2483 6 0 0.402862 14.629930 13.340607 +8677 2483 4 0 -0.252964 15.247709 13.638832 +8678 2483 4 0 0.540834 14.019125 14.040061 +8679 2484 6 0 12.212673 -14.561562 8.432466 +8680 2484 4 0 12.964986 -15.158798 8.469829 +8681 2484 4 0 12.315635 -13.749340 8.974910 +8682 2485 6 0 -18.091351 14.816669 -20.791191 +8683 2485 4 0 -17.950349 14.394028 -19.955312 +8684 2485 4 0 -17.259160 15.337091 -20.997461 +8685 2486 6 0 20.846407 4.941141 -20.805564 +8686 2486 4 0 20.364445 5.609240 -20.314152 +8687 2486 4 0 21.773006 5.036677 -20.468448 +8688 2487 6 0 -18.235581 1.799447 7.616936 +8689 2487 4 0 -18.663035 2.668602 7.871183 +8690 2487 4 0 -18.147248 1.507995 8.534548 +8691 2488 6 0 12.243946 -10.407747 -4.453069 +8692 2488 4 0 12.758610 -10.750408 -5.173538 +8693 2488 4 0 11.391861 -10.887258 -4.514732 +8694 2489 6 0 -15.999205 -0.324038 16.881023 +8695 2489 4 0 -15.685432 -0.202706 15.976630 +8696 2489 4 0 -15.623326 0.405687 17.366937 +8697 2490 6 0 -23.099614 -14.642217 -19.649766 +8698 2490 4 0 -23.777759 -15.309775 -19.518530 +8699 2490 4 0 -23.241127 -14.411915 -20.620505 +8700 2491 6 0 -12.249488 9.185541 -16.320990 +8701 2491 4 0 -12.902804 8.826914 -16.950148 +8702 2491 4 0 -11.588894 9.548457 -16.894605 +8703 2492 6 0 -4.051701 -13.736377 -16.555628 +8704 2492 4 0 -4.494654 -14.354729 -17.129699 +8705 2492 4 0 -4.462835 -13.910768 -15.684946 +8706 2493 6 0 -11.801200 19.657830 -10.999540 +8707 2493 4 0 -10.902720 19.828996 -11.011831 +8708 2493 4 0 -12.193533 20.466103 -10.567549 +8709 2494 6 0 -24.325618 14.045672 -1.110263 +8710 2494 4 0 -24.668600 14.350444 -0.200830 +8711 2494 4 0 -24.816092 13.231043 -1.195474 +8712 2495 6 0 20.913056 15.489658 -18.886527 +8713 2495 4 0 20.368015 16.190531 -18.479805 +8714 2495 4 0 21.821778 15.751011 -18.640831 +8715 2496 6 0 -20.772862 0.764056 -6.084683 +8716 2496 4 0 -20.333324 1.468628 -5.568275 +8717 2496 4 0 -20.870557 -0.044044 -5.434493 +8718 2497 6 0 -16.073764 -5.000219 -5.989733 +8719 2497 4 0 -15.211568 -4.748827 -5.581555 +8720 2497 4 0 -16.376788 -5.851245 -5.640415 +8721 2498 6 0 -9.856355 -16.695376 -19.135619 +8722 2498 4 0 -10.833867 -16.815665 -19.193496 +8723 2498 4 0 -9.591699 -17.153724 -19.905312 +8724 2499 6 0 -14.392982 0.813400 -5.967904 +8725 2499 4 0 -14.439076 -0.104057 -5.900368 +8726 2499 4 0 -15.047260 1.134714 -6.628678 +8727 2500 6 0 11.045455 -13.563452 -6.886523 +8728 2500 4 0 10.981894 -14.173292 -6.136333 +8729 2500 4 0 10.392197 -12.867802 -6.742279 +8730 2501 6 0 20.205100 13.593403 -6.053417 +8731 2501 4 0 19.481313 14.001651 -6.432278 +8732 2501 4 0 20.986779 14.039356 -6.342708 +8733 2502 6 0 -15.365488 5.137757 1.769971 +8734 2502 4 0 -16.164843 4.770892 1.413857 +8735 2502 4 0 -14.688240 4.932112 1.136328 +8736 2503 6 0 -24.720205 -11.036422 -9.472540 +8737 2503 4 0 -25.299911 -10.766165 -8.734947 +8738 2503 4 0 -25.200381 -11.736926 -9.906125 +8739 2504 6 0 14.559792 11.008849 -19.039727 +8740 2504 4 0 15.234376 11.619514 -18.598604 +8741 2504 4 0 13.848001 10.777673 -18.398174 +8742 2505 6 0 20.737940 13.944347 3.008812 +8743 2505 4 0 19.926090 13.665780 2.507060 +8744 2505 4 0 20.524403 14.681916 3.550067 +8745 2506 6 0 -13.687080 4.284684 12.620334 +8746 2506 4 0 -14.374801 3.638577 12.764178 +8747 2506 4 0 -13.341649 4.114854 11.765071 +8748 2507 6 0 10.858099 -17.177182 -20.193932 +8749 2507 4 0 10.006770 -17.050221 -20.711055 +8750 2507 4 0 11.163899 -17.997677 -20.596267 +8751 2508 6 0 -1.413844 20.882523 -7.532723 +8752 2508 4 0 -0.481522 20.795022 -7.591494 +8753 2508 4 0 -1.734791 20.061230 -7.123891 +8754 2509 6 0 14.883760 4.844985 -11.460983 +8755 2509 4 0 14.857826 5.007527 -12.430076 +8756 2509 4 0 14.543696 3.941245 -11.329620 +8757 2510 6 0 -6.076326 -4.794057 13.123230 +8758 2510 4 0 -7.063204 -4.795068 13.194896 +8759 2510 4 0 -5.787599 -5.455376 13.703743 +8760 2511 6 0 26.801734 19.306820 7.537896 +8761 2511 4 0 27.324481 18.524252 7.345834 +8762 2511 4 0 27.305309 20.057747 7.249205 +8763 2512 6 0 17.631040 11.938297 -2.819567 +8764 2512 4 0 18.494147 11.630708 -2.989743 +8765 2512 4 0 17.500906 12.097849 -1.861896 +8766 2513 6 0 -5.066723 14.593124 8.613540 +8767 2513 4 0 -5.776044 13.928470 8.604036 +8768 2513 4 0 -5.472521 15.379622 8.936421 +8769 2514 6 0 -22.625793 -6.943329 -10.402222 +8770 2514 4 0 -22.918006 -7.487802 -11.106371 +8771 2514 4 0 -22.525718 -6.063678 -10.788262 +8772 2515 6 0 11.828624 -19.683428 -20.603919 +8773 2515 4 0 12.217112 -20.243126 -21.346224 +8774 2515 4 0 12.385880 -19.784195 -19.860322 +8775 2516 6 0 -21.139138 9.961065 13.641562 +8776 2516 4 0 -21.977740 9.505083 13.402813 +8777 2516 4 0 -20.669934 9.781538 12.788303 +8778 2517 6 0 25.519216 -5.515401 1.511029 +8779 2517 4 0 26.084211 -5.177738 0.810141 +8780 2517 4 0 24.693318 -5.003524 1.409607 +8781 2518 6 0 26.272080 10.541058 9.764091 +8782 2518 4 0 25.609606 11.193003 9.426754 +8783 2518 4 0 25.839012 9.942262 10.435364 +8784 2519 6 0 25.016001 0.794303 -1.014649 +8785 2519 4 0 25.368203 0.342397 -1.801633 +8786 2519 4 0 25.407512 1.692440 -0.976171 +8787 2520 6 0 -8.746565 3.936264 -17.089748 +8788 2520 4 0 -8.606611 4.042084 -18.035704 +8789 2520 4 0 -8.750589 2.966468 -16.991948 +8790 2521 6 0 21.588920 13.603723 -12.704304 +8791 2521 4 0 21.601929 14.305164 -12.022119 +8792 2521 4 0 21.312576 14.081953 -13.484692 +8793 2522 6 0 -18.216349 -3.529717 0.360926 +8794 2522 4 0 -18.540051 -2.874458 0.978203 +8795 2522 4 0 -18.963370 -4.161327 0.221890 +8796 2523 6 0 19.308604 17.633776 -17.848331 +8797 2523 4 0 18.426310 17.372206 -17.746813 +8798 2523 4 0 19.313729 18.351135 -18.545042 +8799 2524 6 0 23.180289 12.694539 3.506974 +8800 2524 4 0 22.252060 12.962086 3.303073 +8801 2524 4 0 23.366253 11.863114 3.057800 +8802 2525 6 0 -17.100932 8.883526 -6.444854 +8803 2525 4 0 -16.173403 8.831265 -6.716554 +8804 2525 4 0 -17.583234 8.325208 -7.157965 +8805 2526 6 0 14.323717 15.125299 -5.725594 +8806 2526 4 0 15.041767 15.729064 -5.519842 +8807 2526 4 0 13.765048 15.154023 -4.972067 +8808 2527 6 0 -19.909899 0.941274 -8.892043 +8809 2527 4 0 -20.063118 1.882998 -8.670527 +8810 2527 4 0 -20.016683 0.615676 -7.987400 +8811 2528 6 0 -4.062922 0.518298 17.993285 +8812 2528 4 0 -4.234902 1.391334 17.589117 +8813 2528 4 0 -4.820041 -0.077704 17.801729 +8814 2529 6 0 26.232840 -11.346405 0.934374 +8815 2529 4 0 26.965729 -10.796137 1.273638 +8816 2529 4 0 26.535197 -11.828470 0.207089 +8817 2530 6 0 18.568052 -3.606897 4.561302 +8818 2530 4 0 17.633584 -3.536757 4.401867 +8819 2530 4 0 18.956111 -3.197861 3.755933 +8820 2531 6 0 -23.855092 5.074567 4.116598 +8821 2531 4 0 -23.064224 4.611628 4.537652 +8822 2531 4 0 -23.710838 5.025654 3.139103 +8823 2532 6 0 26.437758 -20.018004 1.491909 +8824 2532 4 0 26.350439 -19.182255 1.070486 +8825 2532 4 0 27.361760 -20.307715 1.508970 +8826 2533 6 0 -15.774583 11.702587 -19.124466 +8827 2533 4 0 -15.128134 11.654611 -18.394652 +8828 2533 4 0 -16.197784 10.854994 -19.059229 +8829 2534 6 0 13.604852 -5.588538 -11.240265 +8830 2534 4 0 13.941716 -4.779794 -10.783187 +8831 2534 4 0 13.492173 -6.306084 -10.658525 +8832 2535 6 0 -4.406927 9.867817 9.346751 +8833 2535 4 0 -5.311013 9.555296 9.655422 +8834 2535 4 0 -4.255731 10.665634 9.843775 +8835 2536 6 0 -5.324087 -1.607821 -19.326145 +8836 2536 4 0 -5.081210 -2.540467 -19.512431 +8837 2536 4 0 -5.681118 -1.658898 -18.424650 +8838 2537 6 0 7.210255 -0.591966 -13.016339 +8839 2537 4 0 7.132769 -0.267418 -12.059025 +8840 2537 4 0 7.145986 0.215754 -13.558300 +8841 2538 6 0 13.031739 18.007964 -16.574884 +8842 2538 4 0 13.701983 18.076453 -17.280260 +8843 2538 4 0 13.560834 18.505150 -15.807835 +8844 2539 6 0 -4.939182 19.582248 2.433779 +8845 2539 4 0 -4.348475 19.232076 1.705221 +8846 2539 4 0 -4.493649 20.306827 2.886563 +8847 2540 6 0 -26.648293 -0.947736 -17.385316 +8848 2540 4 0 -26.109245 -1.287067 -18.123131 +8849 2540 4 0 -27.139044 -0.227784 -17.739830 +8850 2541 6 0 19.417331 5.365442 -12.381828 +8851 2541 4 0 20.057565 6.030330 -12.629842 +8852 2541 4 0 18.801680 5.841907 -11.794057 +8853 2542 6 0 -19.679332 -1.764604 -19.638774 +8854 2542 4 0 -19.289416 -1.940059 -18.795824 +8855 2542 4 0 -19.719754 -0.802184 -19.615952 +8856 2543 6 0 16.188925 -8.137607 9.745803 +8857 2543 4 0 15.895930 -8.655747 9.012990 +8858 2543 4 0 15.671496 -7.334126 9.820282 +8859 2544 6 0 17.367529 -1.265528 20.226689 +8860 2544 4 0 17.209414 -2.128384 20.612209 +8861 2544 4 0 17.475811 -0.580216 20.915152 +8862 2545 6 0 20.517093 9.728672 9.587262 +8863 2545 4 0 21.222551 9.963620 10.212987 +8864 2545 4 0 19.824767 9.384636 10.113042 +8865 2546 6 0 -7.547448 20.192218 -20.533482 +8866 2546 4 0 -6.695025 19.629425 -20.571646 +8867 2546 4 0 -8.008402 20.075383 -21.344144 +8868 2547 6 0 -16.582915 -1.120027 -4.095394 +8869 2547 4 0 -16.849559 -0.208322 -4.049542 +8870 2547 4 0 -16.720426 -1.473779 -3.214581 +8871 2548 6 0 4.785781 1.946407 13.103817 +8872 2548 4 0 4.799308 1.247503 12.424632 +8873 2548 4 0 4.583242 1.575294 13.963927 +8874 2549 6 0 -8.165114 -12.900949 2.168446 +8875 2549 4 0 -8.256829 -12.788477 3.143987 +8876 2549 4 0 -7.320909 -13.341131 2.150781 +8877 2550 6 0 -17.554071 -15.744741 -16.262189 +8878 2550 4 0 -17.806278 -16.375423 -15.592159 +8879 2550 4 0 -18.351583 -15.356631 -16.607464 +8880 2551 6 0 27.326866 4.195826 19.441977 +8881 2551 4 0 28.011431 4.581461 18.842795 +8882 2551 4 0 26.527694 4.615286 19.081611 +8883 2552 6 0 -25.419970 -6.739402 -9.247054 +8884 2552 4 0 -25.459364 -7.498417 -9.890859 +8885 2552 4 0 -24.515740 -6.409622 -9.324420 +8886 2553 6 0 -3.380308 -14.523714 -7.300867 +8887 2553 4 0 -3.061003 -15.308131 -6.909980 +8888 2553 4 0 -2.917512 -14.327994 -8.109098 +8889 2554 6 0 26.207829 15.728093 -19.215945 +8890 2554 4 0 25.966653 16.561497 -19.590938 +8891 2554 4 0 26.062905 14.999376 -19.810656 +8892 2555 6 0 -18.866057 -0.711382 15.470718 +8893 2555 4 0 -19.290122 -1.568096 15.298654 +8894 2555 4 0 -17.951441 -0.972639 15.451259 +8895 2556 6 0 18.465047 8.813449 11.216472 +8896 2556 4 0 18.798663 8.151346 11.818158 +8897 2556 4 0 17.716063 8.381682 10.839333 +8898 2557 6 0 -24.781204 -20.600352 -18.705084 +8899 2557 4 0 -25.022898 -19.710672 -18.985244 +8900 2557 4 0 -25.460136 -21.155945 -19.120654 +8901 2558 6 0 22.729959 2.205214 -7.072615 +8902 2558 4 0 22.357169 1.293535 -7.021078 +8903 2558 4 0 22.701750 2.488699 -7.961356 +8904 2559 6 0 12.690918 2.750591 12.342202 +8905 2559 4 0 12.532985 3.617962 11.878555 +8906 2559 4 0 13.133585 2.199071 11.681589 +8907 2560 6 0 24.106980 -11.846114 14.571893 +8908 2560 4 0 23.699036 -11.148912 15.134462 +8909 2560 4 0 23.233694 -12.194399 14.228632 +8910 2561 6 0 0.015177 -14.005197 -19.056743 +8911 2561 4 0 -0.340775 -13.532157 -18.287023 +8912 2561 4 0 -0.773966 -14.258584 -19.587550 +8913 2562 6 0 12.361724 4.484402 -15.999210 +8914 2562 4 0 12.200963 5.407914 -16.093788 +8915 2562 4 0 11.619804 4.000673 -15.643034 +8916 2563 6 0 -4.332154 14.465183 5.913532 +8917 2563 4 0 -3.550293 15.013973 5.769350 +8918 2563 4 0 -4.511279 14.482735 6.928514 +8919 2564 6 0 -2.423184 -19.036991 20.142811 +8920 2564 4 0 -2.033960 -18.570661 20.871778 +8921 2564 4 0 -2.200093 -18.567230 19.324641 +8922 2565 6 0 -11.400807 16.524027 12.877501 +8923 2565 4 0 -10.684181 16.008719 12.380621 +8924 2565 4 0 -12.191788 16.488834 12.343702 +8925 2566 6 0 15.966093 16.748739 -1.323378 +8926 2566 4 0 16.412638 17.338758 -1.989326 +8927 2566 4 0 15.598457 17.376590 -0.651299 +8928 2567 6 0 23.415752 18.871243 -18.062665 +8929 2567 4 0 23.451778 19.269195 -17.182012 +8930 2567 4 0 22.494121 18.975734 -18.366439 +8931 2568 6 0 -8.572201 3.275476 -10.014766 +8932 2568 4 0 -9.403406 3.269988 -10.503336 +8933 2568 4 0 -8.724278 3.329701 -9.074127 +8934 2569 6 0 -11.585480 -0.851627 12.287499 +8935 2569 4 0 -11.320746 -0.082366 12.769641 +8936 2569 4 0 -11.472816 -0.637183 11.362553 +8937 2570 6 0 7.497602 -9.434427 -12.321588 +8938 2570 4 0 8.071421 -10.126251 -12.076632 +8939 2570 4 0 8.042121 -8.593371 -12.397957 +8940 2571 6 0 4.778213 -10.266015 -19.410251 +8941 2571 4 0 5.274109 -9.668837 -18.817242 +8942 2571 4 0 4.120565 -9.651627 -19.758229 +8943 2572 6 0 -6.111007 -15.043780 2.679188 +8944 2572 4 0 -5.289890 -15.200515 3.239461 +8945 2572 4 0 -6.645239 -15.919834 2.758924 +8946 2573 6 0 -19.627428 -18.648983 -20.285776 +8947 2573 4 0 -18.763886 -19.012576 -20.099994 +8948 2573 4 0 -19.447444 -17.996380 -20.946059 +8949 2574 6 0 9.799336 -4.134177 -14.605227 +8950 2574 4 0 9.726430 -3.298650 -14.107003 +8951 2574 4 0 10.588497 -4.491055 -14.189406 +8952 2575 6 0 6.956853 10.981174 -15.927933 +8953 2575 4 0 6.333575 10.252829 -16.183246 +8954 2575 4 0 7.290948 10.697439 -15.077221 +8955 2576 6 0 15.996505 -7.421222 -2.982722 +8956 2576 4 0 16.037378 -8.363657 -3.163947 +8957 2576 4 0 15.971488 -7.414229 -2.004616 +8958 2577 6 0 24.116659 17.319712 -5.748450 +8959 2577 4 0 24.717303 17.575301 -5.045222 +8960 2577 4 0 24.154648 16.310133 -5.689457 +8961 2578 6 0 -25.014350 19.047244 5.636389 +8962 2578 4 0 -24.831592 18.532801 6.467994 +8963 2578 4 0 -25.569417 19.791621 5.840508 +8964 2579 6 0 -13.760710 14.201790 -16.036971 +8965 2579 4 0 -13.882187 15.099458 -16.440666 +8966 2579 4 0 -13.724599 14.326841 -15.088458 +8967 2580 6 0 -24.389392 17.787413 -4.553817 +8968 2580 4 0 -24.972675 18.418071 -5.068364 +8969 2580 4 0 -24.356964 18.276421 -3.698179 +8970 2581 6 0 -18.723840 -6.150098 -13.057313 +8971 2581 4 0 -18.318192 -6.956567 -12.670367 +8972 2581 4 0 -17.968230 -5.629913 -13.262178 +8973 2582 6 0 0.195836 -4.045493 20.385139 +8974 2582 4 0 0.549498 -4.632208 21.063706 +8975 2582 4 0 -0.603773 -4.486592 20.007533 +8976 2583 6 0 -5.473498 -2.320372 -16.638624 +8977 2583 4 0 -5.812762 -2.143253 -15.717531 +8978 2583 4 0 -5.163919 -3.274843 -16.629360 +8979 2584 6 0 21.657434 10.195244 -12.556194 +8980 2584 4 0 21.466450 11.110479 -12.686972 +8981 2584 4 0 21.662028 10.206355 -11.604800 +8982 2585 6 0 -18.526380 -11.853303 0.119709 +8983 2585 4 0 -18.677742 -12.441590 -0.589422 +8984 2585 4 0 -18.075660 -11.001968 -0.204346 +8985 2586 6 0 -19.755563 -18.537381 -2.766741 +8986 2586 4 0 -19.962233 -18.408807 -3.703137 +8987 2586 4 0 -19.999131 -17.782990 -2.372006 +8988 2587 6 0 25.476128 17.625846 -3.184333 +8989 2587 4 0 26.203145 17.076934 -2.886644 +8990 2587 4 0 25.710710 18.493253 -2.850200 +8991 2588 6 0 -22.305377 1.710018 15.373391 +8992 2588 4 0 -22.044667 1.930929 16.308564 +8993 2588 4 0 -22.836038 0.853232 15.392466 +8994 2589 6 0 2.757401 -15.671844 -1.738405 +8995 2589 4 0 2.387180 -15.115097 -1.096143 +8996 2589 4 0 3.413578 -16.267070 -1.380191 +8997 2590 6 0 25.430670 -2.334847 6.648866 +8998 2590 4 0 25.893201 -2.829135 7.309607 +8999 2590 4 0 24.545839 -2.463509 7.030661 +9000 2591 6 0 3.889750 2.458553 -20.722084 +9001 2591 4 0 3.444777 1.541092 -20.936428 +9002 2591 4 0 3.192280 2.998470 -20.481554 +9003 2592 6 0 19.435277 -5.919201 6.178342 +9004 2592 4 0 18.742497 -6.147165 6.835144 +9005 2592 4 0 19.082846 -5.397301 5.451949 +9006 2593 6 0 -1.325956 10.838557 -7.120140 +9007 2593 4 0 -1.379491 10.683558 -6.153949 +9008 2593 4 0 -1.024828 11.727198 -7.077078 +9009 2594 6 0 -3.710126 14.086716 -7.244913 +9010 2594 4 0 -4.337761 13.541137 -7.799347 +9011 2594 4 0 -4.000550 13.881396 -6.362053 +9012 2595 6 0 14.433778 -1.890208 -13.881242 +9013 2595 4 0 13.768753 -2.557931 -14.088173 +9014 2595 4 0 14.194801 -1.387777 -13.039639 +9015 2596 6 0 -18.934813 -1.053060 1.293190 +9016 2596 4 0 -19.547923 -0.821685 1.967866 +9017 2596 4 0 -18.094001 -0.641682 1.660883 +9018 2597 6 0 -22.405398 -20.039410 9.627718 +9019 2597 4 0 -22.796434 -20.600182 8.972850 +9020 2597 4 0 -22.131968 -19.299630 9.083235 +9021 2598 6 0 -1.229753 11.457428 10.074790 +9022 2598 4 0 -0.334237 11.703470 10.327241 +9023 2598 4 0 -1.157156 10.837370 9.316439 +9024 2599 6 0 25.443002 2.066902 -6.888756 +9025 2599 4 0 25.641541 2.915762 -7.359788 +9026 2599 4 0 24.465208 2.093523 -6.739748 +9027 2600 6 0 -16.581214 16.377510 -14.832297 +9028 2600 4 0 -16.587099 15.904994 -13.968869 +9029 2600 4 0 -16.866698 17.278853 -14.742235 +9030 2601 6 0 11.983368 11.828299 -3.823724 +9031 2601 4 0 12.336985 12.445002 -3.178218 +9032 2601 4 0 11.049304 11.604866 -3.665958 +9033 2602 6 0 21.164572 -1.185333 -16.015117 +9034 2602 4 0 20.715162 -0.431609 -16.354646 +9035 2602 4 0 20.819380 -1.264906 -15.151962 +9036 2603 6 0 5.457366 -10.657358 -13.800772 +9037 2603 4 0 4.779858 -10.165440 -14.279853 +9038 2603 4 0 6.212045 -10.040539 -13.706945 +9039 2604 6 0 -16.423429 10.434483 -15.277807 +9040 2604 4 0 -15.708526 10.928082 -15.699592 +9041 2604 4 0 -15.960741 9.897443 -14.616298 +9042 2605 6 0 -20.419587 -19.665938 5.773644 +9043 2605 4 0 -21.363895 -19.581010 6.013361 +9044 2605 4 0 -19.853905 -19.280863 6.468747 +9045 2606 6 0 19.508036 -18.494331 8.912926 +9046 2606 4 0 19.727428 -18.712582 9.835185 +9047 2606 4 0 19.913134 -19.105692 8.298087 +9048 2607 6 0 19.742354 -2.749373 18.946243 +9049 2607 4 0 20.356111 -2.867791 19.687152 +9050 2607 4 0 19.073759 -2.160527 19.341368 +9051 2608 6 0 19.005725 16.659102 -4.024674 +9052 2608 4 0 18.186097 16.480938 -4.427734 +9053 2608 4 0 18.814608 17.298422 -3.358553 +9054 2609 6 0 -8.835887 18.312505 -7.442487 +9055 2609 4 0 -8.830492 17.732483 -8.193218 +9056 2609 4 0 -9.752425 18.649905 -7.404203 +9057 2610 6 0 -17.336326 4.931650 10.634975 +9058 2610 4 0 -16.450097 5.217439 10.271982 +9059 2610 4 0 -17.882557 4.558518 9.889708 +9060 2611 6 0 -3.010824 -5.905956 6.847801 +9061 2611 4 0 -2.748688 -5.113745 6.359917 +9062 2611 4 0 -2.163371 -6.028171 7.336259 +9063 2612 6 0 26.674110 12.326845 1.003397 +9064 2612 4 0 26.498840 12.357411 1.941376 +9065 2612 4 0 26.095376 11.585032 0.663483 +9066 2613 6 0 -3.647702 -6.137587 13.529843 +9067 2613 4 0 -3.585661 -5.496886 12.804045 +9068 2613 4 0 -3.582668 -6.993279 13.154224 +9069 2614 6 0 1.988731 3.642853 -17.323133 +9070 2614 4 0 1.657523 3.030179 -16.746788 +9071 2614 4 0 1.714357 4.548463 -17.022125 +9072 2615 6 0 -21.467906 15.279507 16.450567 +9073 2615 4 0 -21.342432 15.396388 15.459294 +9074 2615 4 0 -21.255917 16.108495 16.873553 +9075 2616 6 0 10.722659 -15.332451 -4.565762 +9076 2616 4 0 10.219128 -14.832093 -3.873147 +9077 2616 4 0 11.478425 -15.649236 -4.183169 +9078 2617 6 0 -15.362943 8.381189 -9.911049 +9079 2617 4 0 -15.790421 8.852870 -9.163602 +9080 2617 4 0 -15.901457 8.456340 -10.687883 +9081 2618 6 0 -6.117005 -17.666075 11.598739 +9082 2618 4 0 -5.807530 -18.593273 11.402299 +9083 2618 4 0 -5.391363 -17.258909 12.082625 +9084 2619 6 0 15.809786 8.519937 -19.377408 +9085 2619 4 0 15.758815 8.522648 -20.341707 +9086 2619 4 0 15.420577 9.368007 -19.123689 +9087 2620 6 0 16.939240 -18.373645 7.950825 +9088 2620 4 0 17.207858 -18.006941 7.092997 +9089 2620 4 0 17.812610 -18.447723 8.295733 +9090 2621 6 0 -12.507522 -15.054493 6.331021 +9091 2621 4 0 -13.226017 -14.420799 6.460827 +9092 2621 4 0 -11.849976 -14.561229 5.786593 +9093 2622 6 0 -18.182152 4.799952 -11.866172 +9094 2622 4 0 -18.038039 4.897463 -10.917789 +9095 2622 4 0 -18.695958 4.021311 -12.029165 +9096 2623 6 0 -9.377203 11.614184 3.311631 +9097 2623 4 0 -9.092786 10.701027 3.311174 +9098 2623 4 0 -8.739940 12.083447 3.909937 +9099 2624 6 0 24.894256 -5.525807 -20.636863 +9100 2624 4 0 24.507335 -5.547278 -19.753182 +9101 2624 4 0 25.790020 -5.247577 -20.418409 +9102 2625 6 0 -23.172834 -17.188227 2.440789 +9103 2625 4 0 -23.395171 -18.018880 2.825747 +9104 2625 4 0 -22.193387 -17.125237 2.517058 +9105 2626 6 0 24.135008 -19.930490 -4.684991 +9106 2626 4 0 24.122289 -18.925946 -4.803857 +9107 2626 4 0 24.712920 -20.215229 -5.372877 +9108 2627 6 0 -17.792076 11.534192 15.059996 +9109 2627 4 0 -16.965370 11.797213 15.470927 +9110 2627 4 0 -18.560988 11.913780 15.443831 +9111 2628 6 0 -18.514941 20.339905 -0.125520 +9112 2628 4 0 -18.667243 19.462095 -0.535183 +9113 2628 4 0 -18.065408 20.873029 -0.719025 +9114 2629 6 0 -22.940337 -3.988570 -9.248839 +9115 2629 4 0 -22.556330 -3.193733 -8.929657 +9116 2629 4 0 -23.624559 -3.640649 -9.848732 +9117 2630 6 0 12.039511 -1.981999 -19.397718 +9118 2630 4 0 12.283853 -1.068627 -19.717430 +9119 2630 4 0 11.293173 -1.821725 -18.743785 +9120 2631 6 0 26.340624 1.335259 19.289276 +9121 2631 4 0 26.841055 0.655996 19.819897 +9122 2631 4 0 26.800288 2.181296 19.386054 +9123 2632 6 0 5.916695 14.316365 5.690974 +9124 2632 4 0 6.301016 14.102416 4.790199 +9125 2632 4 0 5.065517 13.849361 5.701154 +9126 2633 6 0 13.370348 -18.821001 19.162682 +9127 2633 4 0 14.108633 -19.097802 18.663220 +9128 2633 4 0 13.699085 -18.168012 19.800526 +9129 2634 6 0 23.405805 15.068779 9.736213 +9130 2634 4 0 22.573160 14.660972 10.019951 +9131 2634 4 0 23.219623 15.734719 9.058682 +9132 2635 6 0 -5.408829 13.828838 18.447419 +9133 2635 4 0 -6.168561 13.481395 17.992340 +9134 2635 4 0 -4.784831 14.172206 17.836655 +9135 2636 6 0 -13.245623 5.670961 -0.018513 +9136 2636 4 0 -12.419620 5.936404 0.475256 +9137 2636 4 0 -12.953928 4.989305 -0.645525 +9138 2637 6 0 17.249203 -6.366308 2.555121 +9139 2637 4 0 18.196321 -6.281038 2.412817 +9140 2637 4 0 16.966298 -7.253693 2.384394 +9141 2638 6 0 -5.296416 19.864731 -1.668047 +9142 2638 4 0 -5.749980 19.031441 -1.444019 +9143 2638 4 0 -4.299943 19.722461 -1.604460 +9144 2639 6 0 -16.684535 5.831070 -9.866261 +9145 2639 4 0 -17.133431 6.510584 -9.314798 +9146 2639 4 0 -15.783199 6.112174 -9.905469 +9147 2640 6 0 16.265639 6.852785 -7.896636 +9148 2640 4 0 16.527802 6.700601 -8.808419 +9149 2640 4 0 17.070642 6.577942 -7.414049 +9150 2641 6 0 -21.312105 18.191924 10.459876 +9151 2641 4 0 -20.762633 18.843032 9.983997 +9152 2641 4 0 -20.749711 17.337404 10.555555 +9153 2642 6 0 -16.100357 -8.153697 -5.142815 +9154 2642 4 0 -16.563606 -8.364758 -6.004467 +9155 2642 4 0 -15.154250 -7.906094 -5.382181 +9156 2643 6 0 -9.615286 13.091225 20.211510 +9157 2643 4 0 -9.791366 12.655362 19.395743 +9158 2643 4 0 -10.462726 13.102852 20.699120 +9159 2644 6 0 -18.598056 -9.697384 8.839376 +9160 2644 4 0 -18.669310 -10.516686 9.343906 +9161 2644 4 0 -18.931363 -8.964428 9.385541 +9162 2645 6 0 7.933987 -14.093590 6.186519 +9163 2645 4 0 8.207527 -14.668399 6.884006 +9164 2645 4 0 8.301922 -13.235214 6.418423 +9165 2646 6 0 14.288937 4.874936 -8.228821 +9166 2646 4 0 13.542574 5.155680 -8.863279 +9167 2646 4 0 14.810343 5.654336 -8.058197 +9168 2647 6 0 12.246994 8.643633 9.863872 +9169 2647 4 0 12.726549 8.831956 10.652198 +9170 2647 4 0 11.373287 8.283693 10.003012 +9171 2648 6 0 -25.270711 -9.927997 8.533897 +9172 2648 4 0 -24.762785 -10.112710 9.286810 +9173 2648 4 0 -25.238676 -10.761122 8.058752 +9174 2649 6 0 22.391162 10.881778 -20.435148 +9175 2649 4 0 21.795271 11.117663 -21.128050 +9176 2649 4 0 22.356795 11.558284 -19.773744 +9177 2650 6 0 -0.807548 -14.371789 12.994860 +9178 2650 4 0 0.169556 -14.376294 13.074982 +9179 2650 4 0 -1.104471 -13.660037 12.471373 +9180 2651 6 0 7.732198 13.812736 20.037022 +9181 2651 4 0 8.322105 14.100985 20.697382 +9182 2651 4 0 7.280009 14.639584 19.691732 +9183 2652 6 0 19.803756 0.841082 -17.134900 +9184 2652 4 0 19.288798 0.974936 -16.312323 +9185 2652 4 0 20.344973 1.668924 -17.222026 +9186 2653 6 0 3.006216 10.098697 2.949568 +9187 2653 4 0 2.578021 10.984530 2.806805 +9188 2653 4 0 3.907142 10.297785 3.184074 +9189 2654 6 0 15.873541 13.013460 -17.893320 +9190 2654 4 0 15.039690 13.457379 -17.843027 +9191 2654 4 0 16.307486 13.271147 -17.069099 +9192 2655 6 0 17.084293 4.346353 -14.985379 +9193 2655 4 0 16.897186 4.218804 -15.905422 +9194 2655 4 0 18.061148 4.233803 -14.912436 +9195 2656 6 0 -21.371098 -2.500601 10.634104 +9196 2656 4 0 -21.050859 -3.246995 11.070174 +9197 2656 4 0 -21.156581 -2.501005 9.672558 +9198 2657 6 0 -18.750890 1.105436 13.107103 +9199 2657 4 0 -19.405065 0.422507 13.292755 +9200 2657 4 0 -18.176163 1.261421 13.836264 +9201 2658 6 0 -14.137019 19.297443 5.108564 +9202 2658 4 0 -14.447107 19.586959 4.301598 +9203 2658 4 0 -14.859255 19.041560 5.714699 +9204 2659 6 0 2.347144 -4.353199 10.184512 +9205 2659 4 0 3.047693 -4.789736 10.732160 +9206 2659 4 0 1.864240 -5.020658 9.719618 +9207 2660 6 0 8.101274 -12.868709 15.865572 +9208 2660 4 0 9.008432 -13.290947 15.950755 +9209 2660 4 0 8.164041 -12.117937 16.446599 +9210 2661 6 0 -7.675769 -15.390059 12.539289 +9211 2661 4 0 -7.409496 -14.626553 11.915042 +9212 2661 4 0 -7.614755 -16.191218 12.009248 +9213 2662 6 0 -21.398277 17.515428 0.659811 +9214 2662 4 0 -22.373476 17.461084 0.916402 +9215 2662 4 0 -21.187696 16.555626 0.790839 +9216 2663 6 0 -16.011532 15.600476 -5.525384 +9217 2663 4 0 -15.829552 14.648078 -5.450075 +9218 2663 4 0 -15.676036 15.915857 -6.377072 +9219 2664 6 0 -20.171456 -7.558847 9.362228 +9220 2664 4 0 -19.542732 -6.922489 9.041804 +9221 2664 4 0 -20.565885 -7.210783 10.122068 +9222 2665 6 0 -10.027028 2.569851 14.780708 +9223 2665 4 0 -10.957643 2.497925 14.922514 +9224 2665 4 0 -9.726024 3.392205 15.205842 +9225 2666 6 0 -12.389641 -3.630575 19.832870 +9226 2666 4 0 -12.243221 -2.721357 19.438252 +9227 2666 4 0 -11.816036 -4.199902 19.239521 +9228 2667 6 0 18.688398 -15.142019 -11.646870 +9229 2667 4 0 18.104901 -15.132683 -12.455435 +9230 2667 4 0 19.565818 -14.972254 -11.954461 +9231 2668 6 0 -16.127768 -4.186936 16.465789 +9232 2668 4 0 -16.199826 -5.136635 16.281789 +9233 2668 4 0 -15.213417 -3.948084 16.556706 +9234 2669 6 0 -5.695916 9.820869 12.533783 +9235 2669 4 0 -6.081058 9.297651 11.888045 +9236 2669 4 0 -6.375197 10.194994 13.105807 +9237 2670 6 0 -11.767595 7.371441 19.819990 +9238 2670 4 0 -12.489308 7.774706 20.373473 +9239 2670 4 0 -10.903774 7.497881 20.264329 +9240 2671 6 0 -18.646029 -3.188135 4.429231 +9241 2671 4 0 -18.121897 -2.394969 4.628228 +9242 2671 4 0 -19.564881 -3.024196 4.677418 +9243 2672 6 0 -27.199358 17.790334 15.106308 +9244 2672 4 0 -27.385927 16.881826 14.776421 +9245 2672 4 0 -27.100030 17.729872 16.057267 +9246 2673 6 0 18.093363 3.769702 -4.593442 +9247 2673 4 0 18.609903 3.037301 -4.942422 +9248 2673 4 0 18.650829 4.233336 -3.997439 +9249 2674 6 0 7.706432 11.586595 6.521802 +9250 2674 4 0 7.812472 12.398627 6.995928 +9251 2674 4 0 7.694286 11.737503 5.595545 +9252 2675 6 0 -23.496957 14.349318 18.036220 +9253 2675 4 0 -22.854057 14.699094 17.423607 +9254 2675 4 0 -22.990832 13.822071 18.687726 +9255 2676 6 0 -4.664327 -11.498090 8.919813 +9256 2676 4 0 -5.320061 -11.113845 8.334147 +9257 2676 4 0 -4.917357 -12.403653 9.095316 +9258 2677 6 0 -12.823426 10.100060 12.766547 +9259 2677 4 0 -13.732598 9.891677 12.621183 +9260 2677 4 0 -12.785614 10.926980 13.238539 +9261 2678 6 0 -17.217436 3.102574 -9.344857 +9262 2678 4 0 -16.824523 3.966216 -9.255133 +9263 2678 4 0 -18.161389 3.114177 -9.202666 +9264 2679 6 0 -19.237099 13.102459 19.268997 +9265 2679 4 0 -18.881981 13.843795 19.761617 +9266 2679 4 0 -18.662460 12.340333 19.526666 +9267 2680 6 0 -9.459329 4.127006 -20.423384 +9268 2680 4 0 -9.437953 4.152565 -21.392157 +9269 2680 4 0 -9.259556 3.201676 -20.170944 +9270 2681 6 0 16.881832 1.847629 -10.429065 +9271 2681 4 0 16.137346 2.355903 -10.841218 +9272 2681 4 0 16.970716 2.383474 -9.646384 +9273 2682 6 0 14.087997 4.886317 -18.329611 +9274 2682 4 0 13.870527 5.790902 -18.194453 +9275 2682 4 0 13.733176 4.313827 -17.614840 +9276 2683 6 0 -16.672076 -8.158476 12.371072 +9277 2683 4 0 -16.864374 -8.959184 11.822666 +9278 2683 4 0 -15.812107 -8.255964 12.755980 +9279 2684 6 0 -19.299758 3.045618 -4.235388 +9280 2684 4 0 -19.897059 2.549328 -3.677605 +9281 2684 4 0 -19.150628 3.861874 -3.750292 +9282 2685 6 0 -23.652514 -4.511442 -6.532734 +9283 2685 4 0 -22.727919 -4.287115 -6.467785 +9284 2685 4 0 -23.794359 -4.367125 -7.440392 +9285 2686 6 0 -2.920139 11.742479 14.018818 +9286 2686 4 0 -3.093279 11.094202 13.278761 +9287 2686 4 0 -2.213003 12.387804 13.722639 +9288 2687 6 0 26.349425 3.441434 -0.896655 +9289 2687 4 0 25.559323 3.941367 -0.786766 +9290 2687 4 0 26.827837 3.589174 -1.727789 +9291 2688 6 0 24.371024 -6.950117 11.157076 +9292 2688 4 0 24.363949 -7.335870 12.010991 +9293 2688 4 0 23.997586 -7.623084 10.641501 +9294 2689 6 0 -22.986862 7.597219 -10.685297 +9295 2689 4 0 -22.839220 7.363568 -11.582970 +9296 2689 4 0 -23.377355 8.488181 -10.698170 +9297 2690 6 0 -26.260863 2.606900 0.424694 +9298 2690 4 0 -25.763469 2.340546 -0.362004 +9299 2690 4 0 -27.210163 2.597209 0.142899 +9300 2691 6 0 -12.863331 19.210721 9.863577 +9301 2691 4 0 -12.261758 19.250393 10.674962 +9302 2691 4 0 -13.524604 18.506027 9.993308 +9303 2692 6 0 -21.978336 -14.820148 8.330413 +9304 2692 4 0 -21.114644 -14.929597 7.888749 +9305 2692 4 0 -21.801101 -14.612357 9.239922 +9306 2693 6 0 4.170159 8.312971 19.162038 +9307 2693 4 0 4.570566 7.905151 18.357550 +9308 2693 4 0 3.241810 8.258885 18.904642 +9309 2694 6 0 20.797031 -12.724867 -4.841837 +9310 2694 4 0 20.936034 -13.677427 -4.931553 +9311 2694 4 0 21.567394 -12.221377 -4.833917 +9312 2695 6 0 13.112963 4.999431 10.925314 +9313 2695 4 0 13.381193 5.910915 11.162187 +9314 2695 4 0 12.775168 5.031277 10.023795 +9315 2696 6 0 -17.488498 18.101828 -9.390547 +9316 2696 4 0 -16.811412 18.773847 -9.686587 +9317 2696 4 0 -17.803299 18.410345 -8.511456 +9318 2697 6 0 17.749103 -8.641103 -11.171278 +9319 2697 4 0 17.842099 -7.910400 -11.803229 +9320 2697 4 0 18.554099 -8.647320 -10.650095 +9321 2698 6 0 23.187132 -9.133014 9.904940 +9322 2698 4 0 23.460415 -9.970033 10.292082 +9323 2698 4 0 22.233888 -9.184916 9.742240 +9324 2699 6 0 14.891551 9.368784 -7.655561 +9325 2699 4 0 15.425686 8.571538 -7.734882 +9326 2699 4 0 15.193600 9.946038 -8.368338 +9327 2700 6 0 -23.866954 -2.554397 -3.337520 +9328 2700 4 0 -23.349227 -3.276607 -2.890486 +9329 2700 4 0 -24.593652 -2.997738 -3.796287 +9330 2701 6 0 5.289348 -7.469003 -13.632279 +9331 2701 4 0 5.277377 -6.512734 -13.514077 +9332 2701 4 0 5.158552 -7.590503 -14.588796 +9333 2702 6 0 -24.673900 -20.221091 14.116865 +9334 2702 4 0 -24.507583 -21.124377 14.341508 +9335 2702 4 0 -24.631103 -20.019803 13.186904 +9336 2703 6 0 23.849959 -2.905384 -13.612324 +9337 2703 4 0 23.991560 -2.301635 -14.360144 +9338 2703 4 0 23.035961 -3.322471 -13.648750 +9339 2704 6 0 9.597419 13.539609 16.458855 +9340 2704 4 0 8.786247 13.049602 16.392590 +9341 2704 4 0 9.783350 13.953319 15.588815 +9342 2705 6 0 25.970484 6.179678 15.798539 +9343 2705 4 0 26.018959 6.019011 14.863720 +9344 2705 4 0 26.760326 5.647911 16.135033 +9345 2706 6 0 15.995160 -8.299211 -19.360180 +9346 2706 4 0 16.084534 -7.778026 -20.183460 +9347 2706 4 0 16.045247 -9.240694 -19.615365 +9348 2707 6 0 -14.294639 13.545693 12.129310 +9349 2707 4 0 -14.596139 13.059241 11.355518 +9350 2707 4 0 -13.936091 12.903120 12.762555 +9351 2708 6 0 -19.407809 -1.632719 -10.223791 +9352 2708 4 0 -18.944881 -0.931680 -10.694558 +9353 2708 4 0 -19.337036 -2.518503 -10.649693 +9354 2709 6 0 19.353851 17.575670 17.852735 +9355 2709 4 0 19.970328 18.410638 17.937921 +9356 2709 4 0 18.705869 17.842357 17.182350 +9357 2710 6 0 7.952485 -13.835833 10.779314 +9358 2710 4 0 8.503126 -13.070419 11.090754 +9359 2710 4 0 7.207795 -13.430815 10.322018 +9360 2711 6 0 -22.842698 -2.314944 16.647836 +9361 2711 4 0 -23.333149 -1.519155 16.340397 +9362 2711 4 0 -23.463394 -3.038396 16.463743 +9363 2712 6 0 -19.201717 2.632915 18.127454 +9364 2712 4 0 -20.123441 2.325926 18.179315 +9365 2712 4 0 -19.210821 3.510831 17.811602 +9366 2713 6 0 14.940360 -1.960385 -5.022951 +9367 2713 4 0 15.464903 -2.467492 -5.627366 +9368 2713 4 0 15.028383 -1.068080 -5.249177 +9369 2714 6 0 18.305226 -9.507548 11.469011 +9370 2714 4 0 18.631115 -9.386360 12.404545 +9371 2714 4 0 17.861273 -8.670836 11.223009 +9372 2715 6 0 14.602066 10.381034 5.005010 +9373 2715 4 0 13.693795 10.430464 4.699453 +9374 2715 4 0 14.612959 10.041819 5.921815 +9375 2716 6 0 2.027713 14.335519 -2.737302 +9376 2716 4 0 2.701727 15.041848 -2.820213 +9377 2716 4 0 1.287972 14.760203 -2.236217 +9378 2717 6 0 7.583318 14.155640 -9.444813 +9379 2717 4 0 6.943304 13.664978 -8.934443 +9380 2717 4 0 7.541292 15.069839 -9.060789 +9381 2718 6 0 6.157219 -18.775945 -4.259618 +9382 2718 4 0 6.564876 -17.949995 -4.135465 +9383 2718 4 0 5.381952 -18.685791 -4.858352 +9384 2719 6 0 -17.694760 -19.372982 4.444716 +9385 2719 4 0 -18.482553 -19.775840 4.189782 +9386 2719 4 0 -17.768985 -18.373906 4.216234 +9387 2720 6 0 -7.853241 -10.893164 5.893751 +9388 2720 4 0 -8.018175 -11.113207 6.770281 +9389 2720 4 0 -8.721602 -10.559022 5.533534 +9390 2721 6 0 -0.179053 -16.316262 -6.972426 +9391 2721 4 0 -0.917372 -16.443486 -6.358316 +9392 2721 4 0 0.161491 -15.370029 -6.873414 +9393 2722 6 0 -17.840107 2.077389 4.804516 +9394 2722 4 0 -18.321956 2.898522 4.546830 +9395 2722 4 0 -17.883766 1.968309 5.738130 +9396 2723 6 0 22.514225 -13.301014 8.910658 +9397 2723 4 0 22.980267 -13.555893 9.738284 +9398 2723 4 0 22.816838 -13.961875 8.319245 +9399 2724 6 0 8.642838 -14.756688 -17.347259 +9400 2724 4 0 7.685639 -14.854800 -17.271066 +9401 2724 4 0 9.104821 -15.542415 -17.427483 +9402 2725 6 0 1.148414 -18.182410 2.438452 +9403 2725 4 0 1.244513 -18.018729 1.471145 +9404 2725 4 0 0.297784 -18.622295 2.484621 +9405 2726 6 0 -0.615129 -11.682105 -14.874888 +9406 2726 4 0 -0.743014 -12.466140 -15.424873 +9407 2726 4 0 -0.401037 -10.992229 -15.542345 +9408 2727 6 0 0.382292 8.435158 -17.928055 +9409 2727 4 0 1.324448 8.603691 -17.753474 +9410 2727 4 0 -0.034745 8.730008 -17.117939 +9411 2728 6 0 16.913096 -13.325161 -8.541691 +9412 2728 4 0 17.365381 -13.123665 -7.714485 +9413 2728 4 0 17.395114 -14.047333 -9.044404 +9414 2729 6 0 -21.295513 -11.021940 0.140848 +9415 2729 4 0 -20.399742 -11.414489 0.196618 +9416 2729 4 0 -21.717453 -11.457849 -0.596997 +9417 2730 6 0 16.257153 -20.396691 -7.748186 +9418 2730 4 0 15.866593 -21.141436 -8.252209 +9419 2730 4 0 16.774217 -20.799101 -7.019481 +9420 2731 6 0 0.208862 17.804049 -6.156398 +9421 2731 4 0 -0.761445 17.806961 -6.377662 +9422 2731 4 0 0.362977 16.942869 -5.716103 +9423 2732 6 0 16.820504 12.298715 0.018055 +9424 2732 4 0 17.269628 12.806166 0.753963 +9425 2732 4 0 16.616966 11.447779 0.422257 +9426 2733 6 0 8.249689 9.539413 -5.657026 +9427 2733 4 0 7.926267 8.961633 -4.961649 +9428 2733 4 0 7.466873 9.988595 -6.079963 +9429 2734 6 0 -6.420145 -15.194726 -2.072771 +9430 2734 4 0 -6.645150 -15.017421 -2.971457 +9431 2734 4 0 -5.532921 -14.874756 -2.025757 +9432 2735 6 0 -19.505572 1.070481 -18.793079 +9433 2735 4 0 -18.974247 1.767142 -19.229226 +9434 2735 4 0 -19.357244 1.271413 -17.799689 +9435 2736 6 0 20.278433 -11.278541 19.375197 +9436 2736 4 0 20.311617 -10.856797 20.258994 +9437 2736 4 0 20.934421 -12.034086 19.419062 +9438 2737 6 0 -10.619435 15.949865 1.585511 +9439 2737 4 0 -10.621509 15.567618 2.491670 +9440 2737 4 0 -10.362619 16.916267 1.609401 +9441 2738 6 0 -1.101917 -7.441924 10.586362 +9442 2738 4 0 -0.567999 -7.634893 11.314871 +9443 2738 4 0 -0.711206 -6.670438 10.158382 +9444 2739 6 0 -8.851165 -9.058377 -8.388886 +9445 2739 4 0 -9.044805 -8.277288 -8.905613 +9446 2739 4 0 -7.947771 -9.334823 -8.625881 +9447 2740 6 0 -12.865173 -20.003868 -17.685004 +9448 2740 4 0 -11.900331 -20.290871 -17.648188 +9449 2740 4 0 -13.259242 -20.215643 -16.805809 +9450 2741 6 0 8.134636 3.904853 11.647104 +9451 2741 4 0 7.339621 4.198944 12.086138 +9452 2741 4 0 8.359181 3.015108 11.941173 +9453 2742 6 0 19.642179 -0.232387 9.832126 +9454 2742 4 0 18.865134 -0.769467 9.662648 +9455 2742 4 0 19.348750 0.264237 10.621214 +9456 2743 6 0 -12.682747 8.424040 -10.230134 +9457 2743 4 0 -13.551445 8.389330 -9.854912 +9458 2743 4 0 -12.463391 9.379389 -10.339605 +9459 2744 6 0 26.914440 16.154997 -16.554272 +9460 2744 4 0 26.893167 15.808906 -17.482437 +9461 2744 4 0 26.594368 15.442541 -16.021243 +9462 2745 6 0 -6.756073 6.486074 12.621266 +9463 2745 4 0 -6.001614 6.299854 12.037502 +9464 2745 4 0 -7.537856 6.154367 12.136267 +9465 2746 6 0 -1.534934 -0.378729 -11.255488 +9466 2746 4 0 -1.019268 -0.077205 -12.015010 +9467 2746 4 0 -1.396223 0.199493 -10.524178 +9468 2747 6 0 -7.913402 -19.479583 -10.101731 +9469 2747 4 0 -7.094305 -19.451963 -10.661033 +9470 2747 4 0 -8.430321 -18.659348 -10.306663 +9471 2748 6 0 19.510276 5.438180 15.252043 +9472 2748 4 0 19.984510 4.581515 15.209276 +9473 2748 4 0 18.693891 5.265727 15.619608 +9474 2749 6 0 14.672317 -11.674219 -8.512325 +9475 2749 4 0 15.214654 -10.997268 -8.992741 +9476 2749 4 0 15.271629 -12.444207 -8.537082 +9477 2750 6 0 -26.549973 -17.678593 10.402834 +9478 2750 4 0 -25.763998 -17.483834 10.878590 +9479 2750 4 0 -27.160376 -17.361462 11.034196 +9480 2751 6 0 5.271179 14.438724 -17.415549 +9481 2751 4 0 4.435936 14.151626 -17.136425 +9482 2751 4 0 5.468504 14.023544 -18.253894 +9483 2752 6 0 26.352424 19.290788 19.181784 +9484 2752 4 0 26.638793 20.134863 19.511609 +9485 2752 4 0 27.096123 18.959221 18.597699 +9486 2753 6 0 -26.414188 7.441925 13.185744 +9487 2753 4 0 -26.562431 6.574296 12.885418 +9488 2753 4 0 -25.860420 7.846130 12.499402 +9489 2754 6 0 5.368816 -14.762666 -4.864027 +9490 2754 4 0 6.085752 -14.950510 -4.202359 +9491 2754 4 0 5.366848 -13.815827 -5.050153 +9492 2755 6 0 -1.852223 13.402453 16.099559 +9493 2755 4 0 -0.907053 13.096616 15.950410 +9494 2755 4 0 -2.405269 12.678324 16.442150 +9495 2756 6 0 -9.537989 1.018888 -17.294635 +9496 2756 4 0 -10.174283 0.989703 -18.011766 +9497 2756 4 0 -10.088090 0.844105 -16.509242 +9498 2757 6 0 -4.825860 2.375466 13.925597 +9499 2757 4 0 -4.190822 2.787671 13.323831 +9500 2757 4 0 -5.515449 3.033395 14.087300 +9501 2758 6 0 19.580327 -10.893880 -2.747248 +9502 2758 4 0 19.742431 -11.614878 -3.428406 +9503 2758 4 0 18.622372 -10.972265 -2.491828 +9504 2759 6 0 19.256086 14.705134 10.874402 +9505 2759 4 0 20.041175 14.096992 10.573737 +9506 2759 4 0 18.760180 14.026878 11.366191 +9507 2760 6 0 4.455935 -2.361452 20.137505 +9508 2760 4 0 3.955764 -1.509452 20.278229 +9509 2760 4 0 4.874829 -2.603490 21.001857 +9510 2761 6 0 -25.974850 13.344171 -18.000007 +9511 2761 4 0 -26.267499 12.457368 -18.163639 +9512 2761 4 0 -26.149308 13.539735 -17.037715 +9513 2762 6 0 17.067973 2.763490 17.660244 +9514 2762 4 0 16.915215 3.437471 16.973312 +9515 2762 4 0 17.816632 2.203161 17.314923 +9516 2763 6 0 -11.517545 18.040646 17.714435 +9517 2763 4 0 -11.560942 17.052444 17.749537 +9518 2763 4 0 -11.413962 18.230547 18.657315 +9519 2764 6 0 25.776483 -1.160860 1.258340 +9520 2764 4 0 26.324116 -0.766625 1.925968 +9521 2764 4 0 25.733053 -0.545865 0.469204 +9522 2765 6 0 0.465549 -19.018322 6.222139 +9523 2765 4 0 0.971697 -19.764727 5.842403 +9524 2765 4 0 1.099427 -18.538006 6.759456 +9525 2766 6 0 26.241049 -6.898960 18.643166 +9526 2766 4 0 25.947101 -5.963940 18.676752 +9527 2766 4 0 25.610721 -7.314304 19.228579 +9528 2767 6 0 16.134037 -10.035813 7.553052 +9529 2767 4 0 16.959970 -10.575559 7.222214 +9530 2767 4 0 16.256703 -9.244050 7.026849 +9531 2768 6 0 22.936475 16.842438 -13.354400 +9532 2768 4 0 23.113117 16.122413 -13.952998 +9533 2768 4 0 22.167217 17.380611 -13.705166 +9534 2769 6 0 -6.174635 -12.567358 -9.759225 +9535 2769 4 0 -7.056186 -12.732423 -10.081695 +9536 2769 4 0 -6.114005 -12.989145 -8.857709 +9537 2770 6 0 13.127494 -17.049020 5.559108 +9538 2770 4 0 12.909499 -17.802411 4.984143 +9539 2770 4 0 12.442780 -16.360937 5.316305 +9540 2771 6 0 10.969996 20.716828 15.837969 +9541 2771 4 0 10.927306 20.477406 14.883647 +9542 2771 4 0 11.840696 20.306837 16.078361 +9543 2772 6 0 13.866770 18.367517 6.937702 +9544 2772 4 0 13.986130 19.326827 7.078015 +9545 2772 4 0 14.231164 17.993652 7.716184 +9546 2773 6 0 13.832788 12.943646 -11.273375 +9547 2773 4 0 14.056108 12.521321 -12.121074 +9548 2773 4 0 13.085693 12.513389 -10.836623 +9549 2774 6 0 17.127641 6.332315 -10.642348 +9550 2774 4 0 16.719396 7.195424 -10.818370 +9551 2774 4 0 16.487151 5.750510 -10.856669 +9552 2775 6 0 7.636882 -18.482195 20.548956 +9553 2775 4 0 7.346233 -18.787052 19.666640 +9554 2775 4 0 8.040956 -17.608352 20.385186 +9555 2776 6 0 15.587474 -5.247845 -16.278347 +9556 2776 4 0 16.572338 -5.288530 -16.165720 +9557 2776 4 0 15.545571 -4.364820 -16.698452 +9558 2777 6 0 0.738994 10.421255 -19.729083 +9559 2777 4 0 0.031346 10.313580 -20.434784 +9560 2777 4 0 0.614162 9.625359 -19.156085 +9561 2778 6 0 -21.514700 17.398643 -8.313387 +9562 2778 4 0 -21.261038 18.368357 -8.523940 +9563 2778 4 0 -20.879597 16.869528 -8.849738 +9564 2779 6 0 21.659354 19.006928 20.763229 +9565 2779 4 0 22.346807 19.674088 20.960616 +9566 2779 4 0 22.147607 18.139994 20.600269 +9567 2780 6 0 -13.226723 20.003033 16.874806 +9568 2780 4 0 -12.786621 19.156341 16.987387 +9569 2780 4 0 -13.521849 20.036703 15.939938 +9570 2781 6 0 12.035825 14.976596 17.699907 +9571 2781 4 0 11.299148 14.549820 17.199522 +9572 2781 4 0 12.476396 14.244702 18.105024 +9573 2782 6 0 23.014725 11.421066 -1.195826 +9574 2782 4 0 22.935852 12.296840 -0.719881 +9575 2782 4 0 23.315744 11.556530 -2.052974 +9576 2783 6 0 21.005599 -13.607746 -17.329690 +9577 2783 4 0 20.264961 -13.783556 -16.739494 +9578 2783 4 0 21.692829 -14.155085 -17.164895 +9579 2784 6 0 19.390018 13.715877 -9.986126 +9580 2784 4 0 18.766137 13.984667 -10.642161 +9581 2784 4 0 18.882708 13.584906 -9.182021 +9582 2785 6 0 21.591458 2.844658 -17.196608 +9583 2785 4 0 21.687177 3.186923 -18.110216 +9584 2785 4 0 22.488513 2.580610 -17.004967 +9585 2786 6 0 11.345787 -11.914521 18.833564 +9586 2786 4 0 10.571637 -11.320431 18.801840 +9587 2786 4 0 11.974322 -11.433977 19.432443 +9588 2787 6 0 14.649482 -19.545223 8.356804 +9589 2787 4 0 14.003078 -18.851322 8.539351 +9590 2787 4 0 15.599308 -19.149367 8.338570 +9591 2788 6 0 -11.043193 -18.255867 17.281239 +9592 2788 4 0 -10.224926 -18.639865 16.994545 +9593 2788 4 0 -11.487164 -19.009987 17.634582 +9594 2789 6 0 -26.985345 -16.412246 -14.400881 +9595 2789 4 0 -27.454047 -15.606813 -14.379952 +9596 2789 4 0 -26.081841 -16.159237 -14.585861 +9597 2790 6 0 19.102051 -15.098666 -8.764412 +9598 2790 4 0 19.000932 -15.521094 -9.678404 +9599 2790 4 0 19.453733 -14.174347 -8.910357 +9600 2791 6 0 6.376012 19.349948 5.671135 +9601 2791 4 0 6.687862 20.029372 5.077314 +9602 2791 4 0 5.561947 19.709229 6.038539 +9603 2792 6 0 -17.499998 -13.507016 9.684050 +9604 2792 4 0 -17.138230 -13.962493 10.435127 +9605 2792 4 0 -17.640659 -14.284861 9.096248 +9606 2793 6 0 17.699807 -14.814698 11.789809 +9607 2793 4 0 17.014114 -15.422000 11.369433 +9608 2793 4 0 17.429825 -14.840034 12.737607 +9609 2794 6 0 12.888820 1.939624 -17.757092 +9610 2794 4 0 12.023501 2.459281 -17.778689 +9611 2794 4 0 12.922205 1.789197 -16.837552 +9612 2795 6 0 -27.142428 -4.791675 -8.608453 +9613 2795 4 0 -27.117499 -4.179414 -9.373351 +9614 2795 4 0 -26.563163 -5.561210 -8.869517 +9615 2796 6 0 18.673615 12.370651 6.319082 +9616 2796 4 0 18.699459 11.385010 6.253835 +9617 2796 4 0 18.583561 12.688817 5.434396 +9618 2797 6 0 10.178364 -12.605036 -17.136500 +9619 2797 4 0 10.699128 -12.924478 -16.370473 +9620 2797 4 0 9.489391 -13.311993 -17.195335 +9621 2798 6 0 7.257958 3.289333 16.273726 +9622 2798 4 0 7.801701 4.023865 16.654114 +9623 2798 4 0 6.831954 2.726700 16.945762 +9624 2799 6 0 -22.793525 -4.351149 1.112435 +9625 2799 4 0 -23.178683 -4.998212 1.686297 +9626 2799 4 0 -22.676437 -3.490820 1.495852 +9627 2800 6 0 10.431915 10.150385 6.416596 +9628 2800 4 0 9.504032 10.369808 6.525826 +9629 2800 4 0 10.818627 10.534325 7.222492 +9630 2801 6 0 16.181318 -18.659361 -4.530126 +9631 2801 4 0 16.539581 -18.491898 -3.640666 +9632 2801 4 0 16.723714 -18.083763 -5.128977 +9633 2802 6 0 24.085884 14.331318 -5.367949 +9634 2802 4 0 25.027794 14.190212 -5.345575 +9635 2802 4 0 23.725489 13.957121 -4.548465 +9636 2803 6 0 27.476267 18.553177 -13.120949 +9637 2803 4 0 27.278972 18.193548 -12.233661 +9638 2803 4 0 26.663894 18.473337 -13.667172 +9639 2804 6 0 -3.429941 10.490939 1.565767 +9640 2804 4 0 -4.189571 9.996973 1.988486 +9641 2804 4 0 -2.756994 10.462029 2.200444 +9642 2805 6 0 -23.874077 -2.287625 -14.406474 +9643 2805 4 0 -24.326434 -2.528790 -13.612508 +9644 2805 4 0 -23.725821 -1.349091 -14.150316 +9645 2806 6 0 6.913124 -5.939231 14.325196 +9646 2806 4 0 7.603991 -5.675852 13.760866 +9647 2806 4 0 7.141094 -6.840164 14.586103 +9648 2807 6 0 -9.435672 7.567999 -12.736311 +9649 2807 4 0 -10.092450 7.532344 -13.480723 +9650 2807 4 0 -9.904849 7.166688 -11.970693 +9651 2808 6 0 -23.627772 20.561997 -10.291642 +9652 2808 4 0 -23.140188 21.403417 -10.120507 +9653 2808 4 0 -23.127330 19.939171 -10.860601 +9654 2809 6 0 -11.957151 -10.758767 10.380421 +9655 2809 4 0 -12.914975 -11.025570 10.474104 +9656 2809 4 0 -11.726864 -10.328942 11.254768 +9657 2810 6 0 -4.055025 -16.357375 12.638110 +9658 2810 4 0 -4.145602 -15.539307 12.188903 +9659 2810 4 0 -3.229424 -16.754351 12.492730 +9660 2811 6 0 -25.660951 2.977355 3.644209 +9661 2811 4 0 -25.405729 3.847728 3.825406 +9662 2811 4 0 -26.592530 3.015138 3.572516 +9663 2812 6 0 -1.059386 -9.814838 20.360215 +9664 2812 4 0 -0.131280 -9.654603 20.258879 +9665 2812 4 0 -1.404044 -10.175480 19.521783 +9666 2813 6 0 -13.274409 -12.355600 6.487680 +9667 2813 4 0 -14.175655 -12.374044 6.195808 +9668 2813 4 0 -12.869043 -11.626070 5.932127 +9669 2814 6 0 -17.154642 -17.337539 -2.602671 +9670 2814 4 0 -17.684268 -17.711860 -3.323318 +9671 2814 4 0 -17.542126 -17.638492 -1.768263 +9672 2815 6 0 -8.431986 -14.331490 -18.620988 +9673 2815 4 0 -8.525378 -14.518157 -17.652352 +9674 2815 4 0 -9.070115 -15.091242 -18.962501 +9675 2816 6 0 9.227734 -14.707755 8.334683 +9676 2816 4 0 8.912750 -14.297078 9.180099 +9677 2816 4 0 10.141362 -14.864367 8.460368 +9678 2817 6 0 -18.940927 -7.749229 13.986681 +9679 2817 4 0 -18.998677 -8.736236 14.046068 +9680 2817 4 0 -18.235160 -7.570709 13.352401 +9681 2818 6 0 -3.315848 14.486693 12.321029 +9682 2818 4 0 -2.891118 14.428375 11.433488 +9683 2818 4 0 -3.009257 15.355409 12.649294 +9684 2819 6 0 15.258302 19.640916 -9.495586 +9685 2819 4 0 15.255790 19.268774 -10.417780 +9686 2819 4 0 14.362167 19.825595 -9.329840 +9687 2820 6 0 -27.308827 -17.253050 -3.549375 +9688 2820 4 0 -27.016406 -16.762829 -2.812626 +9689 2820 4 0 -26.618283 -17.291456 -4.216078 +9690 2821 6 0 -17.469474 9.268976 13.624133 +9691 2821 4 0 -17.003981 8.734120 14.281842 +9692 2821 4 0 -17.567961 10.133200 14.047196 +9693 2822 6 0 20.896249 -8.668059 -15.648620 +9694 2822 4 0 21.320419 -8.468808 -14.797523 +9695 2822 4 0 20.936901 -9.602395 -15.783740 +9696 2823 6 0 6.591038 13.945476 -6.677072 +9697 2823 4 0 6.387452 12.989743 -6.664344 +9698 2823 4 0 7.535066 14.092588 -6.670539 +9699 2824 6 0 10.072634 7.484666 6.879205 +9700 2824 4 0 9.218040 7.159172 6.564500 +9701 2824 4 0 10.122197 8.421774 6.591601 +9702 2825 6 0 -23.792275 5.951536 11.433857 +9703 2825 4 0 -23.560372 6.167334 12.401775 +9704 2825 4 0 -23.076924 6.327786 10.856454 +9705 2826 6 0 12.132840 3.851033 -6.616749 +9706 2826 4 0 12.785083 4.216573 -7.191058 +9707 2826 4 0 12.512257 3.897859 -5.719717 +9708 2827 6 0 5.351683 6.078049 -14.255102 +9709 2827 4 0 5.013358 6.855687 -13.813494 +9710 2827 4 0 5.137704 6.252225 -15.124513 +9711 2828 6 0 13.138157 -8.336001 1.684188 +9712 2828 4 0 12.595335 -8.813255 1.081700 +9713 2828 4 0 13.382247 -7.459796 1.264391 +9714 2829 6 0 -10.347292 10.399621 -12.874082 +9715 2829 4 0 -10.494653 9.452942 -12.814808 +9716 2829 4 0 -10.828227 10.775518 -13.651328 +9717 2830 6 0 9.152946 -17.315622 6.377534 +9718 2830 4 0 8.873272 -17.655423 5.536131 +9719 2830 4 0 9.644625 -16.466151 6.247065 +9720 2831 6 0 -2.422355 -14.638070 -20.255326 +9721 2831 4 0 -2.466677 -15.603006 -20.125891 +9722 2831 4 0 -2.234204 -14.630853 -21.192244 +9723 2832 6 0 7.306601 16.960372 -8.356338 +9724 2832 4 0 7.335426 17.713766 -8.966973 +9725 2832 4 0 6.389385 16.681622 -8.314986 +9726 2833 6 0 -11.068015 -16.691381 7.975224 +9727 2833 4 0 -11.725330 -17.098102 8.584468 +9728 2833 4 0 -11.554703 -15.995305 7.530686 +9729 2834 6 0 2.086903 -14.793471 13.604939 +9730 2834 4 0 2.196059 -15.680487 13.948768 +9731 2834 4 0 2.568411 -14.755595 12.759739 +9732 2835 6 0 -17.658207 18.277094 2.186303 +9733 2835 4 0 -17.424686 17.674490 1.472227 +9734 2835 4 0 -18.244002 18.909136 1.776504 +9735 2836 6 0 24.999903 10.057013 0.434977 +9736 2836 4 0 24.330807 10.404778 -0.199378 +9737 2836 4 0 24.595385 9.375992 1.021837 + +Bonds + +1 1 1 2 +2 2 1 5 +3 2 1 6 +4 2 1 7 +5 3 2 3 +6 4 2 8 +7 5 2 9 +8 6 3 4 +9 7 3 20 +10 8 9 10 +11 9 9 13 +12 9 9 14 +13 10 10 11 +14 9 10 15 +15 9 10 16 +16 10 11 12 +17 9 12 17 +18 9 12 18 +19 9 12 19 +20 11 20 21 +21 12 20 24 +22 3 21 22 +23 4 21 25 +24 5 21 26 +25 6 22 23 +26 7 22 37 +27 8 26 27 +28 9 26 31 +29 9 26 32 +30 13 27 28 +31 9 27 33 +32 9 27 34 +33 6 28 29 +34 7 28 30 +35 12 30 35 +36 12 30 36 +37 11 37 38 +38 12 37 41 +39 3 38 39 +40 4 38 42 +41 14 38 43 +42 6 39 40 +43 7 39 56 +44 5 43 44 +45 5 43 45 +46 4 43 47 +47 8 44 46 +48 9 44 48 +49 9 44 49 +50 9 45 50 +51 9 45 51 +52 9 45 52 +53 9 46 53 +54 9 46 54 +55 9 46 55 +56 11 56 57 +57 12 56 60 +58 3 57 58 +59 4 57 61 +60 5 57 62 +61 6 58 59 +62 7 58 76 +63 15 62 63 +64 9 62 69 +65 9 62 70 +66 16 63 64 +67 16 63 65 +68 16 64 66 +69 17 64 71 +70 16 65 67 +71 17 65 72 +72 16 66 68 +73 17 66 73 +74 16 67 68 +75 17 67 74 +76 17 68 75 +77 11 76 77 +78 12 76 80 +79 3 77 78 +80 4 77 81 +81 14 77 82 +82 6 78 79 +83 7 78 92 +84 5 82 83 +85 5 82 84 +86 4 82 85 +87 9 83 86 +88 9 83 87 +89 9 83 88 +90 9 84 89 +91 9 84 90 +92 9 84 91 +93 11 92 93 +94 12 92 96 +95 3 93 94 +96 4 93 97 +97 5 93 98 +98 6 94 95 +99 7 94 114 +100 8 98 99 +101 9 98 103 +102 9 98 104 +103 8 99 100 +104 9 99 105 +105 9 99 106 +106 8 100 101 +107 9 100 107 +108 9 100 108 +109 18 101 102 +110 9 101 109 +111 9 101 110 +112 19 102 111 +113 19 102 112 +114 19 102 113 +115 11 114 115 +116 12 114 118 +117 3 115 116 +118 4 115 119 +119 14 115 120 +120 6 116 117 +121 7 116 128 +122 20 120 121 +123 5 120 122 +124 4 120 123 +125 21 121 124 +126 9 122 125 +127 9 122 126 +128 9 122 127 +129 11 128 129 +130 12 128 132 +131 3 129 130 +132 4 129 133 +133 5 129 134 +134 6 130 131 +135 7 130 147 +136 5 134 135 +137 9 134 138 +138 9 134 139 +139 5 135 136 +140 5 135 137 +141 4 135 140 +142 9 136 141 +143 9 136 142 +144 9 136 143 +145 9 137 144 +146 9 137 145 +147 9 137 146 +148 11 147 148 +149 12 147 151 +150 3 148 149 +151 4 148 152 +152 14 148 153 +153 6 149 150 +154 7 149 161 +155 20 153 154 +156 5 153 155 +157 4 153 156 +158 21 154 157 +159 9 155 158 +160 9 155 159 +161 9 155 160 +162 22 161 162 +163 12 161 165 +164 23 162 163 +165 24 162 166 +166 24 162 167 +167 6 163 164 +168 7 163 168 +169 11 168 169 +170 12 168 172 +171 3 169 170 +172 4 169 173 +173 5 169 174 +174 6 170 171 +175 7 170 190 +176 8 174 175 +177 9 174 179 +178 9 174 180 +179 8 175 176 +180 9 175 181 +181 9 175 182 +182 8 176 177 +183 9 176 183 +184 9 176 184 +185 18 177 178 +186 9 177 185 +187 9 177 186 +188 19 178 187 +189 19 178 188 +190 19 178 189 +191 11 190 191 +192 12 190 194 +193 3 191 192 +194 4 191 195 +195 14 191 196 +196 6 192 193 +197 7 192 204 +198 20 196 197 +199 5 196 198 +200 4 196 199 +201 21 197 200 +202 9 198 201 +203 9 198 202 +204 9 198 203 +205 11 204 205 +206 12 204 208 +207 3 205 206 +208 4 205 209 +209 14 205 210 +210 6 206 207 +211 7 206 223 +212 5 210 211 +213 5 210 212 +214 4 210 214 +215 8 211 213 +216 9 211 215 +217 9 211 216 +218 9 212 217 +219 9 212 218 +220 9 212 219 +221 9 213 220 +222 9 213 221 +223 9 213 222 +224 11 223 224 +225 12 223 227 +226 3 224 225 +227 4 224 228 +228 14 224 229 +229 6 225 226 +230 7 225 237 +231 20 229 230 +232 5 229 231 +233 4 229 232 +234 21 230 233 +235 9 231 234 +236 9 231 235 +237 9 231 236 +238 11 237 238 +239 12 237 241 +240 3 238 239 +241 4 238 242 +242 5 238 243 +243 6 239 240 +244 7 239 256 +245 5 243 244 +246 9 243 247 +247 9 243 248 +248 5 244 245 +249 5 244 246 +250 4 244 249 +251 9 245 250 +252 9 245 251 +253 9 245 252 +254 9 246 253 +255 9 246 254 +256 9 246 255 +257 11 256 257 +258 12 256 260 +259 3 257 258 +260 4 257 261 +261 5 257 262 +262 6 258 259 +263 7 258 271 +264 8 262 263 +265 9 262 267 +266 9 262 268 +267 25 263 264 +268 9 263 269 +269 9 263 270 +270 26 264 265 +271 26 264 266 +272 11 271 272 +273 12 271 275 +274 3 272 273 +275 4 272 276 +276 14 272 277 +277 6 273 274 +278 7 273 287 +279 5 277 278 +280 5 277 279 +281 4 277 280 +282 9 278 281 +283 9 278 282 +284 9 278 283 +285 9 279 284 +286 9 279 285 +287 9 279 286 +288 11 287 288 +289 12 287 291 +290 3 288 289 +291 4 288 292 +292 5 288 293 +293 6 289 290 +294 27 289 302 +295 8 293 294 +296 9 293 298 +297 9 293 299 +298 25 294 295 +299 9 294 300 +300 9 294 301 +301 26 295 296 +302 26 295 297 +303 28 302 303 +304 29 302 309 +305 3 303 304 +306 4 303 306 +307 30 303 307 +308 6 304 305 +309 7 304 316 +310 31 307 308 +311 32 307 310 +312 32 307 311 +313 31 308 309 +314 32 308 312 +315 32 308 313 +316 33 309 314 +317 33 309 315 +318 11 316 317 +319 12 316 320 +320 3 317 318 +321 4 317 321 +322 5 317 322 +323 6 318 319 +324 7 318 327 +325 34 322 323 +326 9 322 324 +327 9 322 325 +328 21 323 326 +329 11 327 328 +330 12 327 331 +331 3 328 329 +332 4 328 332 +333 5 328 333 +334 6 329 330 +335 7 329 339 +336 25 333 334 +337 9 333 337 +338 9 333 338 +339 26 334 335 +340 26 334 336 +341 11 339 340 +342 12 339 343 +343 3 340 341 +344 4 340 344 +345 14 340 345 +346 6 341 342 +347 7 341 353 +348 20 345 346 +349 5 345 347 +350 4 345 348 +351 21 346 349 +352 9 347 350 +353 9 347 351 +354 9 347 352 +355 11 353 354 +356 12 353 357 +357 3 354 355 +358 4 354 358 +359 14 354 359 +360 6 355 356 +361 7 355 372 +362 5 359 360 +363 5 359 361 +364 4 359 363 +365 8 360 362 +366 9 360 364 +367 9 360 365 +368 9 361 366 +369 9 361 367 +370 9 361 368 +371 9 362 369 +372 9 362 370 +373 9 362 371 +374 11 372 373 +375 12 372 376 +376 3 373 374 +377 4 373 377 +378 5 373 378 +379 6 374 375 +380 7 374 387 +381 8 378 379 +382 9 378 383 +383 9 378 384 +384 25 379 380 +385 9 379 385 +386 9 379 386 +387 26 380 381 +388 26 380 382 +389 11 387 388 +390 12 387 391 +391 3 388 389 +392 4 388 392 +393 5 388 393 +394 6 389 390 +395 7 389 401 +396 13 393 394 +397 9 393 397 +398 9 393 398 +399 6 394 395 +400 7 394 396 +401 12 396 399 +402 12 396 400 +403 11 401 402 +404 12 401 405 +405 3 402 403 +406 4 402 406 +407 14 402 407 +408 6 403 404 +409 7 403 417 +410 5 407 408 +411 5 407 409 +412 4 407 410 +413 9 408 411 +414 9 408 412 +415 9 408 413 +416 9 409 414 +417 9 409 415 +418 9 409 416 +419 11 417 418 +420 12 417 421 +421 3 418 419 +422 4 418 422 +423 5 418 423 +424 6 419 420 +425 7 419 439 +426 8 423 424 +427 9 423 428 +428 9 423 429 +429 8 424 425 +430 9 424 430 +431 9 424 431 +432 8 425 426 +433 9 425 432 +434 9 425 433 +435 18 426 427 +436 9 426 434 +437 9 426 435 +438 19 427 436 +439 19 427 437 +440 19 427 438 +441 11 439 440 +442 12 439 443 +443 3 440 441 +444 4 440 444 +445 5 440 445 +446 6 441 442 +447 7 441 449 +448 9 445 446 +449 9 445 447 +450 9 445 448 +451 11 449 450 +452 12 449 453 +453 3 450 451 +454 4 450 454 +455 5 450 455 +456 6 451 452 +457 7 451 471 +458 8 455 456 +459 9 455 460 +460 9 455 461 +461 8 456 457 +462 9 456 462 +463 9 456 463 +464 8 457 458 +465 9 457 464 +466 9 457 465 +467 18 458 459 +468 9 458 466 +469 9 458 467 +470 19 459 468 +471 19 459 469 +472 19 459 470 +473 11 471 472 +474 12 471 475 +475 3 472 473 +476 4 472 476 +477 14 472 477 +478 6 473 474 +479 7 473 490 +480 5 477 478 +481 5 477 479 +482 4 477 481 +483 8 478 480 +484 9 478 482 +485 9 478 483 +486 9 479 484 +487 9 479 485 +488 9 479 486 +489 9 480 487 +490 9 480 488 +491 9 480 489 +492 11 490 491 +493 12 490 494 +494 3 491 492 +495 4 491 495 +496 5 491 496 +497 6 492 493 +498 7 492 507 +499 8 496 497 +500 9 496 501 +501 9 496 502 +502 13 497 498 +503 9 497 503 +504 9 497 504 +505 6 498 499 +506 7 498 500 +507 12 500 505 +508 12 500 506 +509 11 507 508 +510 12 507 511 +511 3 508 509 +512 4 508 512 +513 5 508 513 +514 6 509 510 +515 7 509 519 +516 25 513 514 +517 9 513 517 +518 9 513 518 +519 26 514 515 +520 26 514 516 +521 11 519 520 +522 12 519 523 +523 3 520 521 +524 4 520 524 +525 5 520 525 +526 6 521 522 +527 7 521 541 +528 8 525 526 +529 9 525 530 +530 9 525 531 +531 8 526 527 +532 9 526 532 +533 9 526 533 +534 8 527 528 +535 9 527 534 +536 9 527 535 +537 18 528 529 +538 9 528 536 +539 9 528 537 +540 19 529 538 +541 19 529 539 +542 19 529 540 +543 11 541 542 +544 12 541 545 +545 3 542 543 +546 4 542 546 +547 5 542 547 +548 6 543 544 +549 7 543 556 +550 8 547 548 +551 9 547 552 +552 9 547 553 +553 25 548 549 +554 9 548 554 +555 9 548 555 +556 26 549 550 +557 26 549 551 +558 22 556 557 +559 12 556 560 +560 23 557 558 +561 24 557 561 +562 24 557 562 +563 6 558 559 +564 7 558 563 +565 11 563 564 +566 12 563 567 +567 3 564 565 +568 4 564 568 +569 14 564 569 +570 6 565 566 +571 27 565 582 +572 5 569 570 +573 5 569 571 +574 4 569 573 +575 8 570 572 +576 9 570 574 +577 9 570 575 +578 9 571 576 +579 9 571 577 +580 9 571 578 +581 9 572 579 +582 9 572 580 +583 9 572 581 +584 28 582 583 +585 29 582 589 +586 3 583 584 +587 4 583 586 +588 30 583 587 +589 6 584 585 +590 27 584 596 +591 31 587 588 +592 32 587 590 +593 32 587 591 +594 31 588 589 +595 32 588 592 +596 32 588 593 +597 33 589 594 +598 33 589 595 +599 28 596 597 +600 29 596 603 +601 3 597 598 +602 4 597 600 +603 30 597 601 +604 6 598 599 +605 7 598 610 +606 31 601 602 +607 32 601 604 +608 32 601 605 +609 31 602 603 +610 32 602 606 +611 32 602 607 +612 33 603 608 +613 33 603 609 +614 11 610 611 +615 12 610 614 +616 3 611 612 +617 4 611 615 +618 5 611 616 +619 6 612 613 +620 7 612 622 +621 25 616 617 +622 9 616 620 +623 9 616 621 +624 26 617 618 +625 26 617 619 +626 11 622 623 +627 12 622 626 +628 3 623 624 +629 4 623 627 +630 5 623 628 +631 6 624 625 +632 7 624 639 +633 8 628 629 +634 9 628 633 +635 9 628 634 +636 13 629 630 +637 9 629 635 +638 9 629 636 +639 6 630 631 +640 7 630 632 +641 12 632 637 +642 12 632 638 +643 11 639 640 +644 12 639 643 +645 3 640 641 +646 4 640 644 +647 5 640 645 +648 6 641 642 +649 7 641 656 +650 8 645 646 +651 9 645 650 +652 9 645 651 +653 13 646 647 +654 9 646 652 +655 9 646 653 +656 6 647 648 +657 7 647 649 +658 12 649 654 +659 12 649 655 +660 11 656 657 +661 12 656 660 +662 3 657 658 +663 4 657 661 +664 5 657 662 +665 6 658 659 +666 7 658 680 +667 8 662 663 +668 9 662 669 +669 9 662 670 +670 8 663 664 +671 9 663 671 +672 9 663 672 +673 35 664 665 +674 9 664 673 +675 9 664 674 +676 36 665 666 +677 37 665 675 +678 36 666 667 +679 36 666 668 +680 37 667 676 +681 37 667 677 +682 37 668 678 +683 37 668 679 +684 11 680 681 +685 12 680 684 +686 3 681 682 +687 4 681 685 +688 5 681 686 +689 6 682 683 +690 7 682 699 +691 5 686 687 +692 9 686 690 +693 9 686 691 +694 5 687 688 +695 5 687 689 +696 4 687 692 +697 9 688 693 +698 9 688 694 +699 9 688 695 +700 9 689 696 +701 9 689 697 +702 9 689 698 +703 11 699 700 +704 12 699 703 +705 3 700 701 +706 4 700 704 +707 14 700 705 +708 6 701 702 +709 7 701 718 +710 5 705 706 +711 5 705 707 +712 4 705 709 +713 8 706 708 +714 9 706 710 +715 9 706 711 +716 9 707 712 +717 9 707 713 +718 9 707 714 +719 9 708 715 +720 9 708 716 +721 9 708 717 +722 11 718 719 +723 12 718 722 +724 3 719 720 +725 4 719 723 +726 5 719 724 +727 6 720 721 +728 7 720 738 +729 15 724 725 +730 9 724 731 +731 9 724 732 +732 16 725 726 +733 16 725 727 +734 16 726 728 +735 17 726 733 +736 16 727 729 +737 17 727 734 +738 16 728 730 +739 17 728 735 +740 16 729 730 +741 17 729 736 +742 17 730 737 +743 11 738 739 +744 12 738 742 +745 3 739 740 +746 4 739 743 +747 5 739 744 +748 6 740 741 +749 7 740 748 +750 9 744 745 +751 9 744 746 +752 9 744 747 +753 22 748 749 +754 12 748 752 +755 23 749 750 +756 24 749 753 +757 24 749 754 +758 6 750 751 +759 7 750 755 +760 11 755 756 +761 12 755 759 +762 3 756 757 +763 4 756 760 +764 5 756 761 +765 6 757 758 +766 7 757 777 +767 8 761 762 +768 9 761 766 +769 9 761 767 +770 8 762 763 +771 9 762 768 +772 9 762 769 +773 8 763 764 +774 9 763 770 +775 9 763 771 +776 18 764 765 +777 9 764 772 +778 9 764 773 +779 19 765 774 +780 19 765 775 +781 19 765 776 +782 11 777 778 +783 12 777 781 +784 3 778 779 +785 4 778 782 +786 5 778 783 +787 6 779 780 +788 7 779 794 +789 8 783 784 +790 9 783 788 +791 9 783 789 +792 13 784 785 +793 9 784 790 +794 9 784 791 +795 6 785 786 +796 7 785 787 +797 12 787 792 +798 12 787 793 +799 11 794 795 +800 12 794 798 +801 3 795 796 +802 4 795 799 +803 5 795 800 +804 6 796 797 +805 7 796 813 +806 5 800 801 +807 9 800 804 +808 9 800 805 +809 5 801 802 +810 5 801 803 +811 4 801 806 +812 9 802 807 +813 9 802 808 +814 9 802 809 +815 9 803 810 +816 9 803 811 +817 9 803 812 +818 11 813 814 +819 12 813 817 +820 3 814 815 +821 4 814 818 +822 5 814 819 +823 6 815 816 +824 7 815 828 +825 8 819 820 +826 9 819 824 +827 9 819 825 +828 25 820 821 +829 9 820 826 +830 9 820 827 +831 26 821 822 +832 26 821 823 +833 11 828 829 +834 12 828 832 +835 3 829 830 +836 4 829 833 +837 5 829 834 +838 6 830 831 +839 7 830 840 +840 25 834 835 +841 9 834 838 +842 9 834 839 +843 26 835 836 +844 26 835 837 +845 22 840 841 +846 12 840 844 +847 23 841 842 +848 24 841 845 +849 24 841 846 +850 6 842 843 +851 7 842 847 +852 11 847 848 +853 12 847 851 +854 3 848 849 +855 4 848 852 +856 5 848 853 +857 6 849 850 +858 7 849 871 +859 8 853 854 +860 9 853 860 +861 9 853 861 +862 8 854 855 +863 9 854 862 +864 9 854 863 +865 35 855 856 +866 9 855 864 +867 9 855 865 +868 36 856 857 +869 37 856 866 +870 36 857 858 +871 36 857 859 +872 37 858 867 +873 37 858 868 +874 37 859 869 +875 37 859 870 +876 11 871 872 +877 12 871 875 +878 3 872 873 +879 4 872 876 +880 14 872 877 +881 6 873 874 +882 7 873 885 +883 20 877 878 +884 5 877 879 +885 4 877 880 +886 21 878 881 +887 9 879 882 +888 9 879 883 +889 9 879 884 +890 11 885 886 +891 12 885 889 +892 3 886 887 +893 4 886 890 +894 5 886 891 +895 6 887 888 +896 7 887 904 +897 5 891 892 +898 9 891 895 +899 9 891 896 +900 5 892 893 +901 5 892 894 +902 4 892 897 +903 9 893 898 +904 9 893 899 +905 9 893 900 +906 9 894 901 +907 9 894 902 +908 9 894 903 +909 11 904 905 +910 12 904 908 +911 3 905 906 +912 4 905 909 +913 5 905 910 +914 6 906 907 +915 7 906 915 +916 34 910 911 +917 9 910 912 +918 9 910 913 +919 21 911 914 +920 11 915 916 +921 12 915 919 +922 3 916 917 +923 4 916 920 +924 5 916 921 +925 6 917 918 +926 7 917 927 +927 25 921 922 +928 9 921 925 +929 9 921 926 +930 26 922 923 +931 26 922 924 +932 11 927 928 +933 12 927 931 +934 3 928 929 +935 4 928 932 +936 5 928 933 +937 6 929 930 +938 7 929 948 +939 15 933 934 +940 9 933 941 +941 9 933 942 +942 16 934 935 +943 16 934 936 +944 16 935 937 +945 17 935 943 +946 16 936 938 +947 17 936 944 +948 16 937 939 +949 17 937 945 +950 16 938 939 +951 17 938 946 +952 38 939 940 +953 39 940 947 +954 11 948 949 +955 12 948 952 +956 3 949 950 +957 4 949 953 +958 5 949 954 +959 6 950 951 +960 7 950 962 +961 13 954 955 +962 9 954 958 +963 9 954 959 +964 6 955 956 +965 7 955 957 +966 12 957 960 +967 12 957 961 +968 11 962 963 +969 12 962 966 +970 3 963 964 +971 4 963 967 +972 14 963 968 +973 6 964 965 +974 7 964 981 +975 5 968 969 +976 5 968 970 +977 4 968 972 +978 8 969 971 +979 9 969 973 +980 9 969 974 +981 9 970 975 +982 9 970 976 +983 9 970 977 +984 9 971 978 +985 9 971 979 +986 9 971 980 +987 11 981 982 +988 12 981 985 +989 3 982 983 +990 4 982 986 +991 5 982 987 +992 6 983 984 +993 7 983 998 +994 8 987 988 +995 9 987 992 +996 9 987 993 +997 13 988 989 +998 9 988 994 +999 9 988 995 +1000 6 989 990 +1001 7 989 991 +1002 12 991 996 +1003 12 991 997 +1004 11 998 999 +1005 12 998 1002 +1006 3 999 1000 +1007 4 999 1003 +1008 5 999 1004 +1009 6 1000 1001 +1010 7 1000 1020 +1011 8 1004 1005 +1012 9 1004 1009 +1013 9 1004 1010 +1014 8 1005 1006 +1015 9 1005 1011 +1016 9 1005 1012 +1017 8 1006 1007 +1018 9 1006 1013 +1019 9 1006 1014 +1020 18 1007 1008 +1021 9 1007 1015 +1022 9 1007 1016 +1023 19 1008 1017 +1024 19 1008 1018 +1025 19 1008 1019 +1026 11 1020 1021 +1027 12 1020 1024 +1028 3 1021 1022 +1029 4 1021 1025 +1030 5 1021 1026 +1031 6 1022 1023 +1032 7 1022 1035 +1033 8 1026 1027 +1034 9 1026 1031 +1035 9 1026 1032 +1036 25 1027 1028 +1037 9 1027 1033 +1038 9 1027 1034 +1039 26 1028 1029 +1040 26 1028 1030 +1041 11 1035 1036 +1042 12 1035 1039 +1043 3 1036 1037 +1044 4 1036 1040 +1045 5 1036 1041 +1046 6 1037 1038 +1047 7 1037 1046 +1048 34 1041 1042 +1049 9 1041 1043 +1050 9 1041 1044 +1051 21 1042 1045 +1052 11 1046 1047 +1053 12 1046 1050 +1054 3 1047 1048 +1055 4 1047 1051 +1056 14 1047 1052 +1057 6 1048 1049 +1058 7 1048 1060 +1059 20 1052 1053 +1060 5 1052 1054 +1061 4 1052 1055 +1062 21 1053 1056 +1063 9 1054 1057 +1064 9 1054 1058 +1065 9 1054 1059 +1066 11 1060 1061 +1067 12 1060 1064 +1068 3 1061 1062 +1069 4 1061 1065 +1070 5 1061 1066 +1071 6 1062 1063 +1072 7 1062 1079 +1073 5 1066 1067 +1074 9 1066 1070 +1075 9 1066 1071 +1076 5 1067 1068 +1077 5 1067 1069 +1078 4 1067 1072 +1079 9 1068 1073 +1080 9 1068 1074 +1081 9 1068 1075 +1082 9 1069 1076 +1083 9 1069 1077 +1084 9 1069 1078 +1085 11 1079 1080 +1086 12 1079 1083 +1087 3 1080 1081 +1088 4 1080 1084 +1089 5 1080 1085 +1090 6 1081 1082 +1091 7 1081 1097 +1092 40 1085 1086 +1093 9 1085 1091 +1094 9 1085 1092 +1095 41 1086 1087 +1096 42 1086 1088 +1097 43 1087 1089 +1098 44 1087 1093 +1099 41 1088 1090 +1100 45 1088 1094 +1101 43 1089 1090 +1102 46 1089 1095 +1103 44 1090 1096 +1104 11 1097 1098 +1105 12 1097 1101 +1106 3 1098 1099 +1107 4 1098 1102 +1108 5 1098 1103 +1109 6 1099 1100 +1110 7 1099 1116 +1111 5 1103 1104 +1112 9 1103 1107 +1113 9 1103 1108 +1114 5 1104 1105 +1115 5 1104 1106 +1116 4 1104 1109 +1117 9 1105 1110 +1118 9 1105 1111 +1119 9 1105 1112 +1120 9 1106 1113 +1121 9 1106 1114 +1122 9 1106 1115 +1123 11 1116 1117 +1124 12 1116 1120 +1125 3 1117 1118 +1126 4 1117 1121 +1127 14 1117 1122 +1128 6 1118 1119 +1129 7 1118 1132 +1130 5 1122 1123 +1131 5 1122 1124 +1132 4 1122 1125 +1133 9 1123 1126 +1134 9 1123 1127 +1135 9 1123 1128 +1136 9 1124 1129 +1137 9 1124 1130 +1138 9 1124 1131 +1139 11 1132 1133 +1140 12 1132 1136 +1141 3 1133 1134 +1142 4 1133 1137 +1143 5 1133 1138 +1144 6 1134 1135 +1145 7 1134 1151 +1146 5 1138 1139 +1147 9 1138 1142 +1148 9 1138 1143 +1149 5 1139 1140 +1150 5 1139 1141 +1151 4 1139 1144 +1152 9 1140 1145 +1153 9 1140 1146 +1154 9 1140 1147 +1155 9 1141 1148 +1156 9 1141 1149 +1157 9 1141 1150 +1158 11 1151 1152 +1159 12 1151 1155 +1160 3 1152 1153 +1161 4 1152 1156 +1162 5 1152 1157 +1163 6 1153 1154 +1164 7 1153 1175 +1165 8 1157 1158 +1166 9 1157 1164 +1167 9 1157 1165 +1168 8 1158 1159 +1169 9 1158 1166 +1170 9 1158 1167 +1171 35 1159 1160 +1172 9 1159 1168 +1173 9 1159 1169 +1174 36 1160 1161 +1175 37 1160 1170 +1176 36 1161 1162 +1177 36 1161 1163 +1178 37 1162 1171 +1179 37 1162 1172 +1180 37 1163 1173 +1181 37 1163 1174 +1182 11 1175 1176 +1183 12 1175 1179 +1184 3 1176 1177 +1185 4 1176 1180 +1186 5 1176 1181 +1187 6 1177 1178 +1188 7 1177 1194 +1189 5 1181 1182 +1190 9 1181 1185 +1191 9 1181 1186 +1192 5 1182 1183 +1193 5 1182 1184 +1194 4 1182 1187 +1195 9 1183 1188 +1196 9 1183 1189 +1197 9 1183 1190 +1198 9 1184 1191 +1199 9 1184 1192 +1200 9 1184 1193 +1201 11 1194 1195 +1202 12 1194 1198 +1203 3 1195 1196 +1204 4 1195 1199 +1205 5 1195 1200 +1206 6 1196 1197 +1207 7 1196 1218 +1208 8 1200 1201 +1209 9 1200 1207 +1210 9 1200 1208 +1211 8 1201 1202 +1212 9 1201 1209 +1213 9 1201 1210 +1214 35 1202 1203 +1215 9 1202 1211 +1216 9 1202 1212 +1217 36 1203 1204 +1218 37 1203 1213 +1219 36 1204 1205 +1220 36 1204 1206 +1221 37 1205 1214 +1222 37 1205 1215 +1223 37 1206 1216 +1224 37 1206 1217 +1225 22 1218 1219 +1226 12 1218 1222 +1227 23 1219 1220 +1228 24 1219 1223 +1229 24 1219 1224 +1230 6 1220 1221 +1231 7 1220 1225 +1232 22 1225 1226 +1233 12 1225 1229 +1234 47 1226 1227 +1235 24 1226 1230 +1236 24 1226 1231 +1237 26 1227 1228 +1238 26 1227 1232 +1239 48 1233 1234 +1240 48 1233 1235 +1241 48 1236 1237 +1242 48 1236 1238 +1243 48 1239 1240 +1244 48 1239 1241 +1245 48 1242 1243 +1246 48 1242 1244 +1247 48 1245 1246 +1248 48 1245 1247 +1249 48 1248 1249 +1250 48 1248 1250 +1251 48 1251 1252 +1252 48 1251 1253 +1253 48 1254 1255 +1254 48 1254 1256 +1255 48 1257 1258 +1256 48 1257 1259 +1257 48 1260 1261 +1258 48 1260 1262 +1259 48 1263 1264 +1260 48 1263 1265 +1261 48 1266 1267 +1262 48 1266 1268 +1263 48 1269 1270 +1264 48 1269 1271 +1265 48 1272 1273 +1266 48 1272 1274 +1267 48 1275 1276 +1268 48 1275 1277 +1269 48 1278 1279 +1270 48 1278 1280 +1271 48 1281 1282 +1272 48 1281 1283 +1273 48 1284 1285 +1274 48 1284 1286 +1275 48 1287 1288 +1276 48 1287 1289 +1277 48 1290 1291 +1278 48 1290 1292 +1279 48 1293 1294 +1280 48 1293 1295 +1281 48 1296 1297 +1282 48 1296 1298 +1283 48 1299 1300 +1284 48 1299 1301 +1285 48 1302 1303 +1286 48 1302 1304 +1287 48 1305 1306 +1288 48 1305 1307 +1289 48 1308 1309 +1290 48 1308 1310 +1291 48 1311 1312 +1292 48 1311 1313 +1293 48 1314 1315 +1294 48 1314 1316 +1295 48 1317 1318 +1296 48 1317 1319 +1297 48 1320 1321 +1298 48 1320 1322 +1299 48 1323 1324 +1300 48 1323 1325 +1301 48 1326 1327 +1302 48 1326 1328 +1303 48 1329 1330 +1304 48 1329 1331 +1305 48 1332 1333 +1306 48 1332 1334 +1307 48 1335 1336 +1308 48 1335 1337 +1309 48 1338 1339 +1310 48 1338 1340 +1311 48 1341 1342 +1312 48 1341 1343 +1313 48 1344 1345 +1314 48 1344 1346 +1315 48 1347 1348 +1316 48 1347 1349 +1317 48 1350 1351 +1318 48 1350 1352 +1319 48 1353 1354 +1320 48 1353 1355 +1321 48 1356 1357 +1322 48 1356 1358 +1323 48 1359 1360 +1324 48 1359 1361 +1325 48 1362 1363 +1326 48 1362 1364 +1327 48 1365 1366 +1328 48 1365 1367 +1329 48 1368 1369 +1330 48 1368 1370 +1331 48 1371 1372 +1332 48 1371 1373 +1333 48 1374 1375 +1334 48 1374 1376 +1335 48 1377 1378 +1336 48 1377 1379 +1337 48 1380 1381 +1338 48 1380 1382 +1339 48 1383 1384 +1340 48 1383 1385 +1341 48 1386 1387 +1342 48 1386 1388 +1343 48 1389 1390 +1344 48 1389 1391 +1345 48 1392 1393 +1346 48 1392 1394 +1347 48 1395 1396 +1348 48 1395 1397 +1349 48 1398 1399 +1350 48 1398 1400 +1351 48 1401 1402 +1352 48 1401 1403 +1353 48 1404 1405 +1354 48 1404 1406 +1355 48 1407 1408 +1356 48 1407 1409 +1357 48 1410 1411 +1358 48 1410 1412 +1359 48 1413 1414 +1360 48 1413 1415 +1361 48 1416 1417 +1362 48 1416 1418 +1363 48 1419 1420 +1364 48 1419 1421 +1365 48 1422 1423 +1366 48 1422 1424 +1367 48 1425 1426 +1368 48 1425 1427 +1369 48 1428 1429 +1370 48 1428 1430 +1371 48 1431 1432 +1372 48 1431 1433 +1373 48 1434 1435 +1374 48 1434 1436 +1375 48 1437 1438 +1376 48 1437 1439 +1377 48 1440 1441 +1378 48 1440 1442 +1379 48 1443 1444 +1380 48 1443 1445 +1381 48 1446 1447 +1382 48 1446 1448 +1383 48 1449 1450 +1384 48 1449 1451 +1385 48 1452 1453 +1386 48 1452 1454 +1387 48 1455 1456 +1388 48 1455 1457 +1389 48 1458 1459 +1390 48 1458 1460 +1391 48 1461 1462 +1392 48 1461 1463 +1393 48 1464 1465 +1394 48 1464 1466 +1395 48 1467 1468 +1396 48 1467 1469 +1397 48 1470 1471 +1398 48 1470 1472 +1399 48 1473 1474 +1400 48 1473 1475 +1401 48 1476 1477 +1402 48 1476 1478 +1403 48 1479 1480 +1404 48 1479 1481 +1405 48 1482 1483 +1406 48 1482 1484 +1407 48 1485 1486 +1408 48 1485 1487 +1409 48 1488 1489 +1410 48 1488 1490 +1411 48 1491 1492 +1412 48 1491 1493 +1413 48 1494 1495 +1414 48 1494 1496 +1415 48 1497 1498 +1416 48 1497 1499 +1417 48 1500 1501 +1418 48 1500 1502 +1419 48 1503 1504 +1420 48 1503 1505 +1421 48 1506 1507 +1422 48 1506 1508 +1423 48 1509 1510 +1424 48 1509 1511 +1425 48 1512 1513 +1426 48 1512 1514 +1427 48 1515 1516 +1428 48 1515 1517 +1429 48 1518 1519 +1430 48 1518 1520 +1431 48 1521 1522 +1432 48 1521 1523 +1433 48 1524 1525 +1434 48 1524 1526 +1435 48 1527 1528 +1436 48 1527 1529 +1437 48 1530 1531 +1438 48 1530 1532 +1439 48 1533 1534 +1440 48 1533 1535 +1441 48 1536 1537 +1442 48 1536 1538 +1443 48 1539 1540 +1444 48 1539 1541 +1445 48 1542 1543 +1446 48 1542 1544 +1447 48 1545 1546 +1448 48 1545 1547 +1449 48 1548 1549 +1450 48 1548 1550 +1451 48 1551 1552 +1452 48 1551 1553 +1453 48 1554 1555 +1454 48 1554 1556 +1455 48 1557 1558 +1456 48 1557 1559 +1457 48 1560 1561 +1458 48 1560 1562 +1459 48 1563 1564 +1460 48 1563 1565 +1461 48 1566 1567 +1462 48 1566 1568 +1463 48 1569 1570 +1464 48 1569 1571 +1465 48 1572 1573 +1466 48 1572 1574 +1467 48 1575 1576 +1468 48 1575 1577 +1469 48 1578 1579 +1470 48 1578 1580 +1471 48 1581 1582 +1472 48 1581 1583 +1473 48 1584 1585 +1474 48 1584 1586 +1475 48 1587 1588 +1476 48 1587 1589 +1477 48 1590 1591 +1478 48 1590 1592 +1479 48 1593 1594 +1480 48 1593 1595 +1481 48 1596 1597 +1482 48 1596 1598 +1483 48 1599 1600 +1484 48 1599 1601 +1485 48 1602 1603 +1486 48 1602 1604 +1487 48 1605 1606 +1488 48 1605 1607 +1489 48 1608 1609 +1490 48 1608 1610 +1491 48 1611 1612 +1492 48 1611 1613 +1493 48 1614 1615 +1494 48 1614 1616 +1495 48 1617 1618 +1496 48 1617 1619 +1497 48 1620 1621 +1498 48 1620 1622 +1499 48 1623 1624 +1500 48 1623 1625 +1501 48 1626 1627 +1502 48 1626 1628 +1503 48 1629 1630 +1504 48 1629 1631 +1505 48 1632 1633 +1506 48 1632 1634 +1507 48 1635 1636 +1508 48 1635 1637 +1509 48 1638 1639 +1510 48 1638 1640 +1511 48 1641 1642 +1512 48 1641 1643 +1513 48 1644 1645 +1514 48 1644 1646 +1515 48 1647 1648 +1516 48 1647 1649 +1517 48 1650 1651 +1518 48 1650 1652 +1519 48 1653 1654 +1520 48 1653 1655 +1521 48 1656 1657 +1522 48 1656 1658 +1523 48 1659 1660 +1524 48 1659 1661 +1525 48 1662 1663 +1526 48 1662 1664 +1527 48 1665 1666 +1528 48 1665 1667 +1529 48 1668 1669 +1530 48 1668 1670 +1531 48 1671 1672 +1532 48 1671 1673 +1533 48 1674 1675 +1534 48 1674 1676 +1535 48 1677 1678 +1536 48 1677 1679 +1537 48 1680 1681 +1538 48 1680 1682 +1539 48 1683 1684 +1540 48 1683 1685 +1541 48 1686 1687 +1542 48 1686 1688 +1543 48 1689 1690 +1544 48 1689 1691 +1545 48 1692 1693 +1546 48 1692 1694 +1547 48 1695 1696 +1548 48 1695 1697 +1549 48 1698 1699 +1550 48 1698 1700 +1551 48 1701 1702 +1552 48 1701 1703 +1553 48 1704 1705 +1554 48 1704 1706 +1555 48 1707 1708 +1556 48 1707 1709 +1557 48 1710 1711 +1558 48 1710 1712 +1559 48 1713 1714 +1560 48 1713 1715 +1561 48 1716 1717 +1562 48 1716 1718 +1563 48 1719 1720 +1564 48 1719 1721 +1565 48 1722 1723 +1566 48 1722 1724 +1567 48 1725 1726 +1568 48 1725 1727 +1569 48 1728 1729 +1570 48 1728 1730 +1571 48 1731 1732 +1572 48 1731 1733 +1573 48 1734 1735 +1574 48 1734 1736 +1575 48 1737 1738 +1576 48 1737 1739 +1577 48 1740 1741 +1578 48 1740 1742 +1579 48 1743 1744 +1580 48 1743 1745 +1581 48 1746 1747 +1582 48 1746 1748 +1583 48 1749 1750 +1584 48 1749 1751 +1585 48 1752 1753 +1586 48 1752 1754 +1587 48 1755 1756 +1588 48 1755 1757 +1589 48 1758 1759 +1590 48 1758 1760 +1591 48 1761 1762 +1592 48 1761 1763 +1593 48 1764 1765 +1594 48 1764 1766 +1595 48 1767 1768 +1596 48 1767 1769 +1597 48 1770 1771 +1598 48 1770 1772 +1599 48 1773 1774 +1600 48 1773 1775 +1601 48 1776 1777 +1602 48 1776 1778 +1603 48 1779 1780 +1604 48 1779 1781 +1605 48 1782 1783 +1606 48 1782 1784 +1607 48 1785 1786 +1608 48 1785 1787 +1609 48 1788 1789 +1610 48 1788 1790 +1611 48 1791 1792 +1612 48 1791 1793 +1613 48 1794 1795 +1614 48 1794 1796 +1615 48 1797 1798 +1616 48 1797 1799 +1617 48 1800 1801 +1618 48 1800 1802 +1619 48 1803 1804 +1620 48 1803 1805 +1621 48 1806 1807 +1622 48 1806 1808 +1623 48 1809 1810 +1624 48 1809 1811 +1625 48 1812 1813 +1626 48 1812 1814 +1627 48 1815 1816 +1628 48 1815 1817 +1629 48 1818 1819 +1630 48 1818 1820 +1631 48 1821 1822 +1632 48 1821 1823 +1633 48 1824 1825 +1634 48 1824 1826 +1635 48 1827 1828 +1636 48 1827 1829 +1637 48 1830 1831 +1638 48 1830 1832 +1639 48 1833 1834 +1640 48 1833 1835 +1641 48 1836 1837 +1642 48 1836 1838 +1643 48 1839 1840 +1644 48 1839 1841 +1645 48 1842 1843 +1646 48 1842 1844 +1647 48 1845 1846 +1648 48 1845 1847 +1649 48 1848 1849 +1650 48 1848 1850 +1651 48 1851 1852 +1652 48 1851 1853 +1653 48 1854 1855 +1654 48 1854 1856 +1655 48 1857 1858 +1656 48 1857 1859 +1657 48 1860 1861 +1658 48 1860 1862 +1659 48 1863 1864 +1660 48 1863 1865 +1661 48 1866 1867 +1662 48 1866 1868 +1663 48 1869 1870 +1664 48 1869 1871 +1665 48 1872 1873 +1666 48 1872 1874 +1667 48 1875 1876 +1668 48 1875 1877 +1669 48 1878 1879 +1670 48 1878 1880 +1671 48 1881 1882 +1672 48 1881 1883 +1673 48 1884 1885 +1674 48 1884 1886 +1675 48 1887 1888 +1676 48 1887 1889 +1677 48 1890 1891 +1678 48 1890 1892 +1679 48 1893 1894 +1680 48 1893 1895 +1681 48 1896 1897 +1682 48 1896 1898 +1683 48 1899 1900 +1684 48 1899 1901 +1685 48 1902 1903 +1686 48 1902 1904 +1687 48 1905 1906 +1688 48 1905 1907 +1689 48 1908 1909 +1690 48 1908 1910 +1691 48 1911 1912 +1692 48 1911 1913 +1693 48 1914 1915 +1694 48 1914 1916 +1695 48 1917 1918 +1696 48 1917 1919 +1697 48 1920 1921 +1698 48 1920 1922 +1699 48 1923 1924 +1700 48 1923 1925 +1701 48 1926 1927 +1702 48 1926 1928 +1703 48 1929 1930 +1704 48 1929 1931 +1705 48 1932 1933 +1706 48 1932 1934 +1707 48 1935 1936 +1708 48 1935 1937 +1709 48 1938 1939 +1710 48 1938 1940 +1711 48 1941 1942 +1712 48 1941 1943 +1713 48 1944 1945 +1714 48 1944 1946 +1715 48 1947 1948 +1716 48 1947 1949 +1717 48 1950 1951 +1718 48 1950 1952 +1719 48 1953 1954 +1720 48 1953 1955 +1721 48 1956 1957 +1722 48 1956 1958 +1723 48 1959 1960 +1724 48 1959 1961 +1725 48 1962 1963 +1726 48 1962 1964 +1727 48 1965 1966 +1728 48 1965 1967 +1729 48 1968 1969 +1730 48 1968 1970 +1731 48 1971 1972 +1732 48 1971 1973 +1733 48 1974 1975 +1734 48 1974 1976 +1735 48 1977 1978 +1736 48 1977 1979 +1737 48 1980 1981 +1738 48 1980 1982 +1739 48 1983 1984 +1740 48 1983 1985 +1741 48 1986 1987 +1742 48 1986 1988 +1743 48 1989 1990 +1744 48 1989 1991 +1745 48 1992 1993 +1746 48 1992 1994 +1747 48 1995 1996 +1748 48 1995 1997 +1749 48 1998 1999 +1750 48 1998 2000 +1751 48 2001 2002 +1752 48 2001 2003 +1753 48 2004 2005 +1754 48 2004 2006 +1755 48 2007 2008 +1756 48 2007 2009 +1757 48 2010 2011 +1758 48 2010 2012 +1759 48 2013 2014 +1760 48 2013 2015 +1761 48 2016 2017 +1762 48 2016 2018 +1763 48 2019 2020 +1764 48 2019 2021 +1765 48 2022 2023 +1766 48 2022 2024 +1767 48 2025 2026 +1768 48 2025 2027 +1769 48 2028 2029 +1770 48 2028 2030 +1771 48 2031 2032 +1772 48 2031 2033 +1773 48 2034 2035 +1774 48 2034 2036 +1775 48 2037 2038 +1776 48 2037 2039 +1777 48 2040 2041 +1778 48 2040 2042 +1779 48 2043 2044 +1780 48 2043 2045 +1781 48 2046 2047 +1782 48 2046 2048 +1783 48 2049 2050 +1784 48 2049 2051 +1785 48 2052 2053 +1786 48 2052 2054 +1787 48 2055 2056 +1788 48 2055 2057 +1789 48 2058 2059 +1790 48 2058 2060 +1791 48 2061 2062 +1792 48 2061 2063 +1793 48 2064 2065 +1794 48 2064 2066 +1795 48 2067 2068 +1796 48 2067 2069 +1797 48 2070 2071 +1798 48 2070 2072 +1799 48 2073 2074 +1800 48 2073 2075 +1801 48 2076 2077 +1802 48 2076 2078 +1803 48 2079 2080 +1804 48 2079 2081 +1805 48 2082 2083 +1806 48 2082 2084 +1807 48 2085 2086 +1808 48 2085 2087 +1809 48 2088 2089 +1810 48 2088 2090 +1811 48 2091 2092 +1812 48 2091 2093 +1813 48 2094 2095 +1814 48 2094 2096 +1815 48 2097 2098 +1816 48 2097 2099 +1817 48 2100 2101 +1818 48 2100 2102 +1819 48 2103 2104 +1820 48 2103 2105 +1821 48 2106 2107 +1822 48 2106 2108 +1823 48 2109 2110 +1824 48 2109 2111 +1825 48 2112 2113 +1826 48 2112 2114 +1827 48 2115 2116 +1828 48 2115 2117 +1829 48 2118 2119 +1830 48 2118 2120 +1831 48 2121 2122 +1832 48 2121 2123 +1833 48 2124 2125 +1834 48 2124 2126 +1835 48 2127 2128 +1836 48 2127 2129 +1837 48 2130 2131 +1838 48 2130 2132 +1839 48 2133 2134 +1840 48 2133 2135 +1841 48 2136 2137 +1842 48 2136 2138 +1843 48 2139 2140 +1844 48 2139 2141 +1845 48 2142 2143 +1846 48 2142 2144 +1847 48 2145 2146 +1848 48 2145 2147 +1849 48 2148 2149 +1850 48 2148 2150 +1851 48 2151 2152 +1852 48 2151 2153 +1853 48 2154 2155 +1854 48 2154 2156 +1855 48 2157 2158 +1856 48 2157 2159 +1857 48 2160 2161 +1858 48 2160 2162 +1859 48 2163 2164 +1860 48 2163 2165 +1861 48 2166 2167 +1862 48 2166 2168 +1863 48 2169 2170 +1864 48 2169 2171 +1865 48 2172 2173 +1866 48 2172 2174 +1867 48 2175 2176 +1868 48 2175 2177 +1869 48 2178 2179 +1870 48 2178 2180 +1871 48 2181 2182 +1872 48 2181 2183 +1873 48 2184 2185 +1874 48 2184 2186 +1875 48 2187 2188 +1876 48 2187 2189 +1877 48 2190 2191 +1878 48 2190 2192 +1879 48 2193 2194 +1880 48 2193 2195 +1881 48 2196 2197 +1882 48 2196 2198 +1883 48 2199 2200 +1884 48 2199 2201 +1885 48 2202 2203 +1886 48 2202 2204 +1887 48 2205 2206 +1888 48 2205 2207 +1889 48 2208 2209 +1890 48 2208 2210 +1891 48 2211 2212 +1892 48 2211 2213 +1893 48 2214 2215 +1894 48 2214 2216 +1895 48 2217 2218 +1896 48 2217 2219 +1897 48 2220 2221 +1898 48 2220 2222 +1899 48 2223 2224 +1900 48 2223 2225 +1901 48 2226 2227 +1902 48 2226 2228 +1903 48 2229 2230 +1904 48 2229 2231 +1905 48 2232 2233 +1906 48 2232 2234 +1907 48 2235 2236 +1908 48 2235 2237 +1909 48 2238 2239 +1910 48 2238 2240 +1911 48 2241 2242 +1912 48 2241 2243 +1913 48 2244 2245 +1914 48 2244 2246 +1915 48 2247 2248 +1916 48 2247 2249 +1917 48 2250 2251 +1918 48 2250 2252 +1919 48 2253 2254 +1920 48 2253 2255 +1921 48 2256 2257 +1922 48 2256 2258 +1923 48 2259 2260 +1924 48 2259 2261 +1925 48 2262 2263 +1926 48 2262 2264 +1927 48 2265 2266 +1928 48 2265 2267 +1929 48 2268 2269 +1930 48 2268 2270 +1931 48 2271 2272 +1932 48 2271 2273 +1933 48 2274 2275 +1934 48 2274 2276 +1935 48 2277 2278 +1936 48 2277 2279 +1937 48 2280 2281 +1938 48 2280 2282 +1939 48 2283 2284 +1940 48 2283 2285 +1941 48 2286 2287 +1942 48 2286 2288 +1943 48 2289 2290 +1944 48 2289 2291 +1945 48 2292 2293 +1946 48 2292 2294 +1947 48 2295 2296 +1948 48 2295 2297 +1949 48 2298 2299 +1950 48 2298 2300 +1951 48 2301 2302 +1952 48 2301 2303 +1953 48 2304 2305 +1954 48 2304 2306 +1955 48 2307 2308 +1956 48 2307 2309 +1957 48 2310 2311 +1958 48 2310 2312 +1959 48 2313 2314 +1960 48 2313 2315 +1961 48 2316 2317 +1962 48 2316 2318 +1963 48 2319 2320 +1964 48 2319 2321 +1965 48 2322 2323 +1966 48 2322 2324 +1967 48 2325 2326 +1968 48 2325 2327 +1969 48 2328 2329 +1970 48 2328 2330 +1971 48 2331 2332 +1972 48 2331 2333 +1973 48 2334 2335 +1974 48 2334 2336 +1975 48 2337 2338 +1976 48 2337 2339 +1977 48 2340 2341 +1978 48 2340 2342 +1979 48 2343 2344 +1980 48 2343 2345 +1981 48 2346 2347 +1982 48 2346 2348 +1983 48 2349 2350 +1984 48 2349 2351 +1985 48 2352 2353 +1986 48 2352 2354 +1987 48 2355 2356 +1988 48 2355 2357 +1989 48 2358 2359 +1990 48 2358 2360 +1991 48 2361 2362 +1992 48 2361 2363 +1993 48 2364 2365 +1994 48 2364 2366 +1995 48 2367 2368 +1996 48 2367 2369 +1997 48 2370 2371 +1998 48 2370 2372 +1999 48 2373 2374 +2000 48 2373 2375 +2001 48 2376 2377 +2002 48 2376 2378 +2003 48 2379 2380 +2004 48 2379 2381 +2005 48 2382 2383 +2006 48 2382 2384 +2007 48 2385 2386 +2008 48 2385 2387 +2009 48 2388 2389 +2010 48 2388 2390 +2011 48 2391 2392 +2012 48 2391 2393 +2013 48 2394 2395 +2014 48 2394 2396 +2015 48 2397 2398 +2016 48 2397 2399 +2017 48 2400 2401 +2018 48 2400 2402 +2019 48 2403 2404 +2020 48 2403 2405 +2021 48 2406 2407 +2022 48 2406 2408 +2023 48 2409 2410 +2024 48 2409 2411 +2025 48 2412 2413 +2026 48 2412 2414 +2027 48 2415 2416 +2028 48 2415 2417 +2029 48 2418 2419 +2030 48 2418 2420 +2031 48 2421 2422 +2032 48 2421 2423 +2033 48 2424 2425 +2034 48 2424 2426 +2035 48 2427 2428 +2036 48 2427 2429 +2037 48 2430 2431 +2038 48 2430 2432 +2039 48 2433 2434 +2040 48 2433 2435 +2041 48 2436 2437 +2042 48 2436 2438 +2043 48 2439 2440 +2044 48 2439 2441 +2045 48 2442 2443 +2046 48 2442 2444 +2047 48 2445 2446 +2048 48 2445 2447 +2049 48 2448 2449 +2050 48 2448 2450 +2051 48 2451 2452 +2052 48 2451 2453 +2053 48 2454 2455 +2054 48 2454 2456 +2055 48 2457 2458 +2056 48 2457 2459 +2057 48 2460 2461 +2058 48 2460 2462 +2059 48 2463 2464 +2060 48 2463 2465 +2061 48 2466 2467 +2062 48 2466 2468 +2063 48 2469 2470 +2064 48 2469 2471 +2065 48 2472 2473 +2066 48 2472 2474 +2067 48 2475 2476 +2068 48 2475 2477 +2069 48 2478 2479 +2070 48 2478 2480 +2071 48 2481 2482 +2072 48 2481 2483 +2073 48 2484 2485 +2074 48 2484 2486 +2075 48 2487 2488 +2076 48 2487 2489 +2077 48 2490 2491 +2078 48 2490 2492 +2079 48 2493 2494 +2080 48 2493 2495 +2081 48 2496 2497 +2082 48 2496 2498 +2083 48 2499 2500 +2084 48 2499 2501 +2085 48 2502 2503 +2086 48 2502 2504 +2087 48 2505 2506 +2088 48 2505 2507 +2089 48 2508 2509 +2090 48 2508 2510 +2091 48 2511 2512 +2092 48 2511 2513 +2093 48 2514 2515 +2094 48 2514 2516 +2095 48 2517 2518 +2096 48 2517 2519 +2097 48 2520 2521 +2098 48 2520 2522 +2099 48 2523 2524 +2100 48 2523 2525 +2101 48 2526 2527 +2102 48 2526 2528 +2103 48 2529 2530 +2104 48 2529 2531 +2105 48 2532 2533 +2106 48 2532 2534 +2107 48 2535 2536 +2108 48 2535 2537 +2109 48 2538 2539 +2110 48 2538 2540 +2111 48 2541 2542 +2112 48 2541 2543 +2113 48 2544 2545 +2114 48 2544 2546 +2115 48 2547 2548 +2116 48 2547 2549 +2117 48 2550 2551 +2118 48 2550 2552 +2119 48 2553 2554 +2120 48 2553 2555 +2121 48 2556 2557 +2122 48 2556 2558 +2123 48 2559 2560 +2124 48 2559 2561 +2125 48 2562 2563 +2126 48 2562 2564 +2127 48 2565 2566 +2128 48 2565 2567 +2129 48 2568 2569 +2130 48 2568 2570 +2131 48 2571 2572 +2132 48 2571 2573 +2133 48 2574 2575 +2134 48 2574 2576 +2135 48 2577 2578 +2136 48 2577 2579 +2137 48 2580 2581 +2138 48 2580 2582 +2139 48 2583 2584 +2140 48 2583 2585 +2141 48 2586 2587 +2142 48 2586 2588 +2143 48 2589 2590 +2144 48 2589 2591 +2145 48 2592 2593 +2146 48 2592 2594 +2147 48 2595 2596 +2148 48 2595 2597 +2149 48 2598 2599 +2150 48 2598 2600 +2151 48 2601 2602 +2152 48 2601 2603 +2153 48 2604 2605 +2154 48 2604 2606 +2155 48 2607 2608 +2156 48 2607 2609 +2157 48 2610 2611 +2158 48 2610 2612 +2159 48 2613 2614 +2160 48 2613 2615 +2161 48 2616 2617 +2162 48 2616 2618 +2163 48 2619 2620 +2164 48 2619 2621 +2165 48 2622 2623 +2166 48 2622 2624 +2167 48 2625 2626 +2168 48 2625 2627 +2169 48 2628 2629 +2170 48 2628 2630 +2171 48 2631 2632 +2172 48 2631 2633 +2173 48 2634 2635 +2174 48 2634 2636 +2175 48 2637 2638 +2176 48 2637 2639 +2177 48 2640 2641 +2178 48 2640 2642 +2179 48 2643 2644 +2180 48 2643 2645 +2181 48 2646 2647 +2182 48 2646 2648 +2183 48 2649 2650 +2184 48 2649 2651 +2185 48 2652 2653 +2186 48 2652 2654 +2187 48 2655 2656 +2188 48 2655 2657 +2189 48 2658 2659 +2190 48 2658 2660 +2191 48 2661 2662 +2192 48 2661 2663 +2193 48 2664 2665 +2194 48 2664 2666 +2195 48 2667 2668 +2196 48 2667 2669 +2197 48 2670 2671 +2198 48 2670 2672 +2199 48 2673 2674 +2200 48 2673 2675 +2201 48 2676 2677 +2202 48 2676 2678 +2203 48 2679 2680 +2204 48 2679 2681 +2205 48 2682 2683 +2206 48 2682 2684 +2207 48 2685 2686 +2208 48 2685 2687 +2209 48 2688 2689 +2210 48 2688 2690 +2211 48 2691 2692 +2212 48 2691 2693 +2213 48 2694 2695 +2214 48 2694 2696 +2215 48 2697 2698 +2216 48 2697 2699 +2217 48 2700 2701 +2218 48 2700 2702 +2219 48 2703 2704 +2220 48 2703 2705 +2221 48 2706 2707 +2222 48 2706 2708 +2223 48 2709 2710 +2224 48 2709 2711 +2225 48 2712 2713 +2226 48 2712 2714 +2227 48 2715 2716 +2228 48 2715 2717 +2229 48 2718 2719 +2230 48 2718 2720 +2231 48 2721 2722 +2232 48 2721 2723 +2233 48 2724 2725 +2234 48 2724 2726 +2235 48 2727 2728 +2236 48 2727 2729 +2237 48 2730 2731 +2238 48 2730 2732 +2239 48 2733 2734 +2240 48 2733 2735 +2241 48 2736 2737 +2242 48 2736 2738 +2243 48 2739 2740 +2244 48 2739 2741 +2245 48 2742 2743 +2246 48 2742 2744 +2247 48 2745 2746 +2248 48 2745 2747 +2249 48 2748 2749 +2250 48 2748 2750 +2251 48 2751 2752 +2252 48 2751 2753 +2253 48 2754 2755 +2254 48 2754 2756 +2255 48 2757 2758 +2256 48 2757 2759 +2257 48 2760 2761 +2258 48 2760 2762 +2259 48 2763 2764 +2260 48 2763 2765 +2261 48 2766 2767 +2262 48 2766 2768 +2263 48 2769 2770 +2264 48 2769 2771 +2265 48 2772 2773 +2266 48 2772 2774 +2267 48 2775 2776 +2268 48 2775 2777 +2269 48 2778 2779 +2270 48 2778 2780 +2271 48 2781 2782 +2272 48 2781 2783 +2273 48 2784 2785 +2274 48 2784 2786 +2275 48 2787 2788 +2276 48 2787 2789 +2277 48 2790 2791 +2278 48 2790 2792 +2279 48 2793 2794 +2280 48 2793 2795 +2281 48 2796 2797 +2282 48 2796 2798 +2283 48 2799 2800 +2284 48 2799 2801 +2285 48 2802 2803 +2286 48 2802 2804 +2287 48 2805 2806 +2288 48 2805 2807 +2289 48 2808 2809 +2290 48 2808 2810 +2291 48 2811 2812 +2292 48 2811 2813 +2293 48 2814 2815 +2294 48 2814 2816 +2295 48 2817 2818 +2296 48 2817 2819 +2297 48 2820 2821 +2298 48 2820 2822 +2299 48 2823 2824 +2300 48 2823 2825 +2301 48 2826 2827 +2302 48 2826 2828 +2303 48 2829 2830 +2304 48 2829 2831 +2305 48 2832 2833 +2306 48 2832 2834 +2307 48 2835 2836 +2308 48 2835 2837 +2309 48 2838 2839 +2310 48 2838 2840 +2311 48 2841 2842 +2312 48 2841 2843 +2313 48 2844 2845 +2314 48 2844 2846 +2315 48 2847 2848 +2316 48 2847 2849 +2317 48 2850 2851 +2318 48 2850 2852 +2319 48 2853 2854 +2320 48 2853 2855 +2321 48 2856 2857 +2322 48 2856 2858 +2323 48 2859 2860 +2324 48 2859 2861 +2325 48 2862 2863 +2326 48 2862 2864 +2327 48 2865 2866 +2328 48 2865 2867 +2329 48 2868 2869 +2330 48 2868 2870 +2331 48 2871 2872 +2332 48 2871 2873 +2333 48 2874 2875 +2334 48 2874 2876 +2335 48 2877 2878 +2336 48 2877 2879 +2337 48 2880 2881 +2338 48 2880 2882 +2339 48 2883 2884 +2340 48 2883 2885 +2341 48 2886 2887 +2342 48 2886 2888 +2343 48 2889 2890 +2344 48 2889 2891 +2345 48 2892 2893 +2346 48 2892 2894 +2347 48 2895 2896 +2348 48 2895 2897 +2349 48 2898 2899 +2350 48 2898 2900 +2351 48 2901 2902 +2352 48 2901 2903 +2353 48 2904 2905 +2354 48 2904 2906 +2355 48 2907 2908 +2356 48 2907 2909 +2357 48 2910 2911 +2358 48 2910 2912 +2359 48 2913 2914 +2360 48 2913 2915 +2361 48 2916 2917 +2362 48 2916 2918 +2363 48 2919 2920 +2364 48 2919 2921 +2365 48 2922 2923 +2366 48 2922 2924 +2367 48 2925 2926 +2368 48 2925 2927 +2369 48 2928 2929 +2370 48 2928 2930 +2371 48 2931 2932 +2372 48 2931 2933 +2373 48 2934 2935 +2374 48 2934 2936 +2375 48 2937 2938 +2376 48 2937 2939 +2377 48 2940 2941 +2378 48 2940 2942 +2379 48 2943 2944 +2380 48 2943 2945 +2381 48 2946 2947 +2382 48 2946 2948 +2383 48 2949 2950 +2384 48 2949 2951 +2385 48 2952 2953 +2386 48 2952 2954 +2387 48 2955 2956 +2388 48 2955 2957 +2389 48 2958 2959 +2390 48 2958 2960 +2391 48 2961 2962 +2392 48 2961 2963 +2393 48 2964 2965 +2394 48 2964 2966 +2395 48 2967 2968 +2396 48 2967 2969 +2397 48 2970 2971 +2398 48 2970 2972 +2399 48 2973 2974 +2400 48 2973 2975 +2401 48 2976 2977 +2402 48 2976 2978 +2403 48 2979 2980 +2404 48 2979 2981 +2405 48 2982 2983 +2406 48 2982 2984 +2407 48 2985 2986 +2408 48 2985 2987 +2409 48 2988 2989 +2410 48 2988 2990 +2411 48 2991 2992 +2412 48 2991 2993 +2413 48 2994 2995 +2414 48 2994 2996 +2415 48 2997 2998 +2416 48 2997 2999 +2417 48 3000 3001 +2418 48 3000 3002 +2419 48 3003 3004 +2420 48 3003 3005 +2421 48 3006 3007 +2422 48 3006 3008 +2423 48 3009 3010 +2424 48 3009 3011 +2425 48 3012 3013 +2426 48 3012 3014 +2427 48 3015 3016 +2428 48 3015 3017 +2429 48 3018 3019 +2430 48 3018 3020 +2431 48 3021 3022 +2432 48 3021 3023 +2433 48 3024 3025 +2434 48 3024 3026 +2435 48 3027 3028 +2436 48 3027 3029 +2437 48 3030 3031 +2438 48 3030 3032 +2439 48 3033 3034 +2440 48 3033 3035 +2441 48 3036 3037 +2442 48 3036 3038 +2443 48 3039 3040 +2444 48 3039 3041 +2445 48 3042 3043 +2446 48 3042 3044 +2447 48 3045 3046 +2448 48 3045 3047 +2449 48 3048 3049 +2450 48 3048 3050 +2451 48 3051 3052 +2452 48 3051 3053 +2453 48 3054 3055 +2454 48 3054 3056 +2455 48 3057 3058 +2456 48 3057 3059 +2457 48 3060 3061 +2458 48 3060 3062 +2459 48 3063 3064 +2460 48 3063 3065 +2461 48 3066 3067 +2462 48 3066 3068 +2463 48 3069 3070 +2464 48 3069 3071 +2465 48 3072 3073 +2466 48 3072 3074 +2467 48 3075 3076 +2468 48 3075 3077 +2469 48 3078 3079 +2470 48 3078 3080 +2471 48 3081 3082 +2472 48 3081 3083 +2473 48 3084 3085 +2474 48 3084 3086 +2475 48 3087 3088 +2476 48 3087 3089 +2477 48 3090 3091 +2478 48 3090 3092 +2479 48 3093 3094 +2480 48 3093 3095 +2481 48 3096 3097 +2482 48 3096 3098 +2483 48 3099 3100 +2484 48 3099 3101 +2485 48 3102 3103 +2486 48 3102 3104 +2487 48 3105 3106 +2488 48 3105 3107 +2489 48 3108 3109 +2490 48 3108 3110 +2491 48 3111 3112 +2492 48 3111 3113 +2493 48 3114 3115 +2494 48 3114 3116 +2495 48 3117 3118 +2496 48 3117 3119 +2497 48 3120 3121 +2498 48 3120 3122 +2499 48 3123 3124 +2500 48 3123 3125 +2501 48 3126 3127 +2502 48 3126 3128 +2503 48 3129 3130 +2504 48 3129 3131 +2505 48 3132 3133 +2506 48 3132 3134 +2507 48 3135 3136 +2508 48 3135 3137 +2509 48 3138 3139 +2510 48 3138 3140 +2511 48 3141 3142 +2512 48 3141 3143 +2513 48 3144 3145 +2514 48 3144 3146 +2515 48 3147 3148 +2516 48 3147 3149 +2517 48 3150 3151 +2518 48 3150 3152 +2519 48 3153 3154 +2520 48 3153 3155 +2521 48 3156 3157 +2522 48 3156 3158 +2523 48 3159 3160 +2524 48 3159 3161 +2525 48 3162 3163 +2526 48 3162 3164 +2527 48 3165 3166 +2528 48 3165 3167 +2529 48 3168 3169 +2530 48 3168 3170 +2531 48 3171 3172 +2532 48 3171 3173 +2533 48 3174 3175 +2534 48 3174 3176 +2535 48 3177 3178 +2536 48 3177 3179 +2537 48 3180 3181 +2538 48 3180 3182 +2539 48 3183 3184 +2540 48 3183 3185 +2541 48 3186 3187 +2542 48 3186 3188 +2543 48 3189 3190 +2544 48 3189 3191 +2545 48 3192 3193 +2546 48 3192 3194 +2547 48 3195 3196 +2548 48 3195 3197 +2549 48 3198 3199 +2550 48 3198 3200 +2551 48 3201 3202 +2552 48 3201 3203 +2553 48 3204 3205 +2554 48 3204 3206 +2555 48 3207 3208 +2556 48 3207 3209 +2557 48 3210 3211 +2558 48 3210 3212 +2559 48 3213 3214 +2560 48 3213 3215 +2561 48 3216 3217 +2562 48 3216 3218 +2563 48 3219 3220 +2564 48 3219 3221 +2565 48 3222 3223 +2566 48 3222 3224 +2567 48 3225 3226 +2568 48 3225 3227 +2569 48 3228 3229 +2570 48 3228 3230 +2571 48 3231 3232 +2572 48 3231 3233 +2573 48 3234 3235 +2574 48 3234 3236 +2575 48 3237 3238 +2576 48 3237 3239 +2577 48 3240 3241 +2578 48 3240 3242 +2579 48 3243 3244 +2580 48 3243 3245 +2581 48 3246 3247 +2582 48 3246 3248 +2583 48 3249 3250 +2584 48 3249 3251 +2585 48 3252 3253 +2586 48 3252 3254 +2587 48 3255 3256 +2588 48 3255 3257 +2589 48 3258 3259 +2590 48 3258 3260 +2591 48 3261 3262 +2592 48 3261 3263 +2593 48 3264 3265 +2594 48 3264 3266 +2595 48 3267 3268 +2596 48 3267 3269 +2597 48 3270 3271 +2598 48 3270 3272 +2599 48 3273 3274 +2600 48 3273 3275 +2601 48 3276 3277 +2602 48 3276 3278 +2603 48 3279 3280 +2604 48 3279 3281 +2605 48 3282 3283 +2606 48 3282 3284 +2607 48 3285 3286 +2608 48 3285 3287 +2609 48 3288 3289 +2610 48 3288 3290 +2611 48 3291 3292 +2612 48 3291 3293 +2613 48 3294 3295 +2614 48 3294 3296 +2615 48 3297 3298 +2616 48 3297 3299 +2617 48 3300 3301 +2618 48 3300 3302 +2619 48 3303 3304 +2620 48 3303 3305 +2621 48 3306 3307 +2622 48 3306 3308 +2623 48 3309 3310 +2624 48 3309 3311 +2625 48 3312 3313 +2626 48 3312 3314 +2627 48 3315 3316 +2628 48 3315 3317 +2629 48 3318 3319 +2630 48 3318 3320 +2631 48 3321 3322 +2632 48 3321 3323 +2633 48 3324 3325 +2634 48 3324 3326 +2635 48 3327 3328 +2636 48 3327 3329 +2637 48 3330 3331 +2638 48 3330 3332 +2639 48 3333 3334 +2640 48 3333 3335 +2641 48 3336 3337 +2642 48 3336 3338 +2643 48 3339 3340 +2644 48 3339 3341 +2645 48 3342 3343 +2646 48 3342 3344 +2647 48 3345 3346 +2648 48 3345 3347 +2649 48 3348 3349 +2650 48 3348 3350 +2651 48 3351 3352 +2652 48 3351 3353 +2653 48 3354 3355 +2654 48 3354 3356 +2655 48 3357 3358 +2656 48 3357 3359 +2657 48 3360 3361 +2658 48 3360 3362 +2659 48 3363 3364 +2660 48 3363 3365 +2661 48 3366 3367 +2662 48 3366 3368 +2663 48 3369 3370 +2664 48 3369 3371 +2665 48 3372 3373 +2666 48 3372 3374 +2667 48 3375 3376 +2668 48 3375 3377 +2669 48 3378 3379 +2670 48 3378 3380 +2671 48 3381 3382 +2672 48 3381 3383 +2673 48 3384 3385 +2674 48 3384 3386 +2675 48 3387 3388 +2676 48 3387 3389 +2677 48 3390 3391 +2678 48 3390 3392 +2679 48 3393 3394 +2680 48 3393 3395 +2681 48 3396 3397 +2682 48 3396 3398 +2683 48 3399 3400 +2684 48 3399 3401 +2685 48 3402 3403 +2686 48 3402 3404 +2687 48 3405 3406 +2688 48 3405 3407 +2689 48 3408 3409 +2690 48 3408 3410 +2691 48 3411 3412 +2692 48 3411 3413 +2693 48 3414 3415 +2694 48 3414 3416 +2695 48 3417 3418 +2696 48 3417 3419 +2697 48 3420 3421 +2698 48 3420 3422 +2699 48 3423 3424 +2700 48 3423 3425 +2701 48 3426 3427 +2702 48 3426 3428 +2703 48 3429 3430 +2704 48 3429 3431 +2705 48 3432 3433 +2706 48 3432 3434 +2707 48 3435 3436 +2708 48 3435 3437 +2709 48 3438 3439 +2710 48 3438 3440 +2711 48 3441 3442 +2712 48 3441 3443 +2713 48 3444 3445 +2714 48 3444 3446 +2715 48 3447 3448 +2716 48 3447 3449 +2717 48 3450 3451 +2718 48 3450 3452 +2719 48 3453 3454 +2720 48 3453 3455 +2721 48 3456 3457 +2722 48 3456 3458 +2723 48 3459 3460 +2724 48 3459 3461 +2725 48 3462 3463 +2726 48 3462 3464 +2727 48 3465 3466 +2728 48 3465 3467 +2729 48 3468 3469 +2730 48 3468 3470 +2731 48 3471 3472 +2732 48 3471 3473 +2733 48 3474 3475 +2734 48 3474 3476 +2735 48 3477 3478 +2736 48 3477 3479 +2737 48 3480 3481 +2738 48 3480 3482 +2739 48 3483 3484 +2740 48 3483 3485 +2741 48 3486 3487 +2742 48 3486 3488 +2743 48 3489 3490 +2744 48 3489 3491 +2745 48 3492 3493 +2746 48 3492 3494 +2747 48 3495 3496 +2748 48 3495 3497 +2749 48 3498 3499 +2750 48 3498 3500 +2751 48 3501 3502 +2752 48 3501 3503 +2753 48 3504 3505 +2754 48 3504 3506 +2755 48 3507 3508 +2756 48 3507 3509 +2757 48 3510 3511 +2758 48 3510 3512 +2759 48 3513 3514 +2760 48 3513 3515 +2761 48 3516 3517 +2762 48 3516 3518 +2763 48 3519 3520 +2764 48 3519 3521 +2765 48 3522 3523 +2766 48 3522 3524 +2767 48 3525 3526 +2768 48 3525 3527 +2769 48 3528 3529 +2770 48 3528 3530 +2771 48 3531 3532 +2772 48 3531 3533 +2773 48 3534 3535 +2774 48 3534 3536 +2775 48 3537 3538 +2776 48 3537 3539 +2777 48 3540 3541 +2778 48 3540 3542 +2779 48 3543 3544 +2780 48 3543 3545 +2781 48 3546 3547 +2782 48 3546 3548 +2783 48 3549 3550 +2784 48 3549 3551 +2785 48 3552 3553 +2786 48 3552 3554 +2787 48 3555 3556 +2788 48 3555 3557 +2789 48 3558 3559 +2790 48 3558 3560 +2791 48 3561 3562 +2792 48 3561 3563 +2793 48 3564 3565 +2794 48 3564 3566 +2795 48 3567 3568 +2796 48 3567 3569 +2797 48 3570 3571 +2798 48 3570 3572 +2799 48 3573 3574 +2800 48 3573 3575 +2801 48 3576 3577 +2802 48 3576 3578 +2803 48 3579 3580 +2804 48 3579 3581 +2805 48 3582 3583 +2806 48 3582 3584 +2807 48 3585 3586 +2808 48 3585 3587 +2809 48 3588 3589 +2810 48 3588 3590 +2811 48 3591 3592 +2812 48 3591 3593 +2813 48 3594 3595 +2814 48 3594 3596 +2815 48 3597 3598 +2816 48 3597 3599 +2817 48 3600 3601 +2818 48 3600 3602 +2819 48 3603 3604 +2820 48 3603 3605 +2821 48 3606 3607 +2822 48 3606 3608 +2823 48 3609 3610 +2824 48 3609 3611 +2825 48 3612 3613 +2826 48 3612 3614 +2827 48 3615 3616 +2828 48 3615 3617 +2829 48 3618 3619 +2830 48 3618 3620 +2831 48 3621 3622 +2832 48 3621 3623 +2833 48 3624 3625 +2834 48 3624 3626 +2835 48 3627 3628 +2836 48 3627 3629 +2837 48 3630 3631 +2838 48 3630 3632 +2839 48 3633 3634 +2840 48 3633 3635 +2841 48 3636 3637 +2842 48 3636 3638 +2843 48 3639 3640 +2844 48 3639 3641 +2845 48 3642 3643 +2846 48 3642 3644 +2847 48 3645 3646 +2848 48 3645 3647 +2849 48 3648 3649 +2850 48 3648 3650 +2851 48 3651 3652 +2852 48 3651 3653 +2853 48 3654 3655 +2854 48 3654 3656 +2855 48 3657 3658 +2856 48 3657 3659 +2857 48 3660 3661 +2858 48 3660 3662 +2859 48 3663 3664 +2860 48 3663 3665 +2861 48 3666 3667 +2862 48 3666 3668 +2863 48 3669 3670 +2864 48 3669 3671 +2865 48 3672 3673 +2866 48 3672 3674 +2867 48 3675 3676 +2868 48 3675 3677 +2869 48 3678 3679 +2870 48 3678 3680 +2871 48 3681 3682 +2872 48 3681 3683 +2873 48 3684 3685 +2874 48 3684 3686 +2875 48 3687 3688 +2876 48 3687 3689 +2877 48 3690 3691 +2878 48 3690 3692 +2879 48 3693 3694 +2880 48 3693 3695 +2881 48 3696 3697 +2882 48 3696 3698 +2883 48 3699 3700 +2884 48 3699 3701 +2885 48 3702 3703 +2886 48 3702 3704 +2887 48 3705 3706 +2888 48 3705 3707 +2889 48 3708 3709 +2890 48 3708 3710 +2891 48 3711 3712 +2892 48 3711 3713 +2893 48 3714 3715 +2894 48 3714 3716 +2895 48 3717 3718 +2896 48 3717 3719 +2897 48 3720 3721 +2898 48 3720 3722 +2899 48 3723 3724 +2900 48 3723 3725 +2901 48 3726 3727 +2902 48 3726 3728 +2903 48 3729 3730 +2904 48 3729 3731 +2905 48 3732 3733 +2906 48 3732 3734 +2907 48 3735 3736 +2908 48 3735 3737 +2909 48 3738 3739 +2910 48 3738 3740 +2911 48 3741 3742 +2912 48 3741 3743 +2913 48 3744 3745 +2914 48 3744 3746 +2915 48 3747 3748 +2916 48 3747 3749 +2917 48 3750 3751 +2918 48 3750 3752 +2919 48 3753 3754 +2920 48 3753 3755 +2921 48 3756 3757 +2922 48 3756 3758 +2923 48 3759 3760 +2924 48 3759 3761 +2925 48 3762 3763 +2926 48 3762 3764 +2927 48 3765 3766 +2928 48 3765 3767 +2929 48 3768 3769 +2930 48 3768 3770 +2931 48 3771 3772 +2932 48 3771 3773 +2933 48 3774 3775 +2934 48 3774 3776 +2935 48 3777 3778 +2936 48 3777 3779 +2937 48 3780 3781 +2938 48 3780 3782 +2939 48 3783 3784 +2940 48 3783 3785 +2941 48 3786 3787 +2942 48 3786 3788 +2943 48 3789 3790 +2944 48 3789 3791 +2945 48 3792 3793 +2946 48 3792 3794 +2947 48 3795 3796 +2948 48 3795 3797 +2949 48 3798 3799 +2950 48 3798 3800 +2951 48 3801 3802 +2952 48 3801 3803 +2953 48 3804 3805 +2954 48 3804 3806 +2955 48 3807 3808 +2956 48 3807 3809 +2957 48 3810 3811 +2958 48 3810 3812 +2959 48 3813 3814 +2960 48 3813 3815 +2961 48 3816 3817 +2962 48 3816 3818 +2963 48 3819 3820 +2964 48 3819 3821 +2965 48 3822 3823 +2966 48 3822 3824 +2967 48 3825 3826 +2968 48 3825 3827 +2969 48 3828 3829 +2970 48 3828 3830 +2971 48 3831 3832 +2972 48 3831 3833 +2973 48 3834 3835 +2974 48 3834 3836 +2975 48 3837 3838 +2976 48 3837 3839 +2977 48 3840 3841 +2978 48 3840 3842 +2979 48 3843 3844 +2980 48 3843 3845 +2981 48 3846 3847 +2982 48 3846 3848 +2983 48 3849 3850 +2984 48 3849 3851 +2985 48 3852 3853 +2986 48 3852 3854 +2987 48 3855 3856 +2988 48 3855 3857 +2989 48 3858 3859 +2990 48 3858 3860 +2991 48 3861 3862 +2992 48 3861 3863 +2993 48 3864 3865 +2994 48 3864 3866 +2995 48 3867 3868 +2996 48 3867 3869 +2997 48 3870 3871 +2998 48 3870 3872 +2999 48 3873 3874 +3000 48 3873 3875 +3001 48 3876 3877 +3002 48 3876 3878 +3003 48 3879 3880 +3004 48 3879 3881 +3005 48 3882 3883 +3006 48 3882 3884 +3007 48 3885 3886 +3008 48 3885 3887 +3009 48 3888 3889 +3010 48 3888 3890 +3011 48 3891 3892 +3012 48 3891 3893 +3013 48 3894 3895 +3014 48 3894 3896 +3015 48 3897 3898 +3016 48 3897 3899 +3017 48 3900 3901 +3018 48 3900 3902 +3019 48 3903 3904 +3020 48 3903 3905 +3021 48 3906 3907 +3022 48 3906 3908 +3023 48 3909 3910 +3024 48 3909 3911 +3025 48 3912 3913 +3026 48 3912 3914 +3027 48 3915 3916 +3028 48 3915 3917 +3029 48 3918 3919 +3030 48 3918 3920 +3031 48 3921 3922 +3032 48 3921 3923 +3033 48 3924 3925 +3034 48 3924 3926 +3035 48 3927 3928 +3036 48 3927 3929 +3037 48 3930 3931 +3038 48 3930 3932 +3039 48 3933 3934 +3040 48 3933 3935 +3041 48 3936 3937 +3042 48 3936 3938 +3043 48 3939 3940 +3044 48 3939 3941 +3045 48 3942 3943 +3046 48 3942 3944 +3047 48 3945 3946 +3048 48 3945 3947 +3049 48 3948 3949 +3050 48 3948 3950 +3051 48 3951 3952 +3052 48 3951 3953 +3053 48 3954 3955 +3054 48 3954 3956 +3055 48 3957 3958 +3056 48 3957 3959 +3057 48 3960 3961 +3058 48 3960 3962 +3059 48 3963 3964 +3060 48 3963 3965 +3061 48 3966 3967 +3062 48 3966 3968 +3063 48 3969 3970 +3064 48 3969 3971 +3065 48 3972 3973 +3066 48 3972 3974 +3067 48 3975 3976 +3068 48 3975 3977 +3069 48 3978 3979 +3070 48 3978 3980 +3071 48 3981 3982 +3072 48 3981 3983 +3073 48 3984 3985 +3074 48 3984 3986 +3075 48 3987 3988 +3076 48 3987 3989 +3077 48 3990 3991 +3078 48 3990 3992 +3079 48 3993 3994 +3080 48 3993 3995 +3081 48 3996 3997 +3082 48 3996 3998 +3083 48 3999 4000 +3084 48 3999 4001 +3085 48 4002 4003 +3086 48 4002 4004 +3087 48 4005 4006 +3088 48 4005 4007 +3089 48 4008 4009 +3090 48 4008 4010 +3091 48 4011 4012 +3092 48 4011 4013 +3093 48 4014 4015 +3094 48 4014 4016 +3095 48 4017 4018 +3096 48 4017 4019 +3097 48 4020 4021 +3098 48 4020 4022 +3099 48 4023 4024 +3100 48 4023 4025 +3101 48 4026 4027 +3102 48 4026 4028 +3103 48 4029 4030 +3104 48 4029 4031 +3105 48 4032 4033 +3106 48 4032 4034 +3107 48 4035 4036 +3108 48 4035 4037 +3109 48 4038 4039 +3110 48 4038 4040 +3111 48 4041 4042 +3112 48 4041 4043 +3113 48 4044 4045 +3114 48 4044 4046 +3115 48 4047 4048 +3116 48 4047 4049 +3117 48 4050 4051 +3118 48 4050 4052 +3119 48 4053 4054 +3120 48 4053 4055 +3121 48 4056 4057 +3122 48 4056 4058 +3123 48 4059 4060 +3124 48 4059 4061 +3125 48 4062 4063 +3126 48 4062 4064 +3127 48 4065 4066 +3128 48 4065 4067 +3129 48 4068 4069 +3130 48 4068 4070 +3131 48 4071 4072 +3132 48 4071 4073 +3133 48 4074 4075 +3134 48 4074 4076 +3135 48 4077 4078 +3136 48 4077 4079 +3137 48 4080 4081 +3138 48 4080 4082 +3139 48 4083 4084 +3140 48 4083 4085 +3141 48 4086 4087 +3142 48 4086 4088 +3143 48 4089 4090 +3144 48 4089 4091 +3145 48 4092 4093 +3146 48 4092 4094 +3147 48 4095 4096 +3148 48 4095 4097 +3149 48 4098 4099 +3150 48 4098 4100 +3151 48 4101 4102 +3152 48 4101 4103 +3153 48 4104 4105 +3154 48 4104 4106 +3155 48 4107 4108 +3156 48 4107 4109 +3157 48 4110 4111 +3158 48 4110 4112 +3159 48 4113 4114 +3160 48 4113 4115 +3161 48 4116 4117 +3162 48 4116 4118 +3163 48 4119 4120 +3164 48 4119 4121 +3165 48 4122 4123 +3166 48 4122 4124 +3167 48 4125 4126 +3168 48 4125 4127 +3169 48 4128 4129 +3170 48 4128 4130 +3171 48 4131 4132 +3172 48 4131 4133 +3173 48 4134 4135 +3174 48 4134 4136 +3175 48 4137 4138 +3176 48 4137 4139 +3177 48 4140 4141 +3178 48 4140 4142 +3179 48 4143 4144 +3180 48 4143 4145 +3181 48 4146 4147 +3182 48 4146 4148 +3183 48 4149 4150 +3184 48 4149 4151 +3185 48 4152 4153 +3186 48 4152 4154 +3187 48 4155 4156 +3188 48 4155 4157 +3189 48 4158 4159 +3190 48 4158 4160 +3191 48 4161 4162 +3192 48 4161 4163 +3193 48 4164 4165 +3194 48 4164 4166 +3195 48 4167 4168 +3196 48 4167 4169 +3197 48 4170 4171 +3198 48 4170 4172 +3199 48 4173 4174 +3200 48 4173 4175 +3201 48 4176 4177 +3202 48 4176 4178 +3203 48 4179 4180 +3204 48 4179 4181 +3205 48 4182 4183 +3206 48 4182 4184 +3207 48 4185 4186 +3208 48 4185 4187 +3209 48 4188 4189 +3210 48 4188 4190 +3211 48 4191 4192 +3212 48 4191 4193 +3213 48 4194 4195 +3214 48 4194 4196 +3215 48 4197 4198 +3216 48 4197 4199 +3217 48 4200 4201 +3218 48 4200 4202 +3219 48 4203 4204 +3220 48 4203 4205 +3221 48 4206 4207 +3222 48 4206 4208 +3223 48 4209 4210 +3224 48 4209 4211 +3225 48 4212 4213 +3226 48 4212 4214 +3227 48 4215 4216 +3228 48 4215 4217 +3229 48 4218 4219 +3230 48 4218 4220 +3231 48 4221 4222 +3232 48 4221 4223 +3233 48 4224 4225 +3234 48 4224 4226 +3235 48 4227 4228 +3236 48 4227 4229 +3237 48 4230 4231 +3238 48 4230 4232 +3239 48 4233 4234 +3240 48 4233 4235 +3241 48 4236 4237 +3242 48 4236 4238 +3243 48 4239 4240 +3244 48 4239 4241 +3245 48 4242 4243 +3246 48 4242 4244 +3247 48 4245 4246 +3248 48 4245 4247 +3249 48 4248 4249 +3250 48 4248 4250 +3251 48 4251 4252 +3252 48 4251 4253 +3253 48 4254 4255 +3254 48 4254 4256 +3255 48 4257 4258 +3256 48 4257 4259 +3257 48 4260 4261 +3258 48 4260 4262 +3259 48 4263 4264 +3260 48 4263 4265 +3261 48 4266 4267 +3262 48 4266 4268 +3263 48 4269 4270 +3264 48 4269 4271 +3265 48 4272 4273 +3266 48 4272 4274 +3267 48 4275 4276 +3268 48 4275 4277 +3269 48 4278 4279 +3270 48 4278 4280 +3271 48 4281 4282 +3272 48 4281 4283 +3273 48 4284 4285 +3274 48 4284 4286 +3275 48 4287 4288 +3276 48 4287 4289 +3277 48 4290 4291 +3278 48 4290 4292 +3279 48 4293 4294 +3280 48 4293 4295 +3281 48 4296 4297 +3282 48 4296 4298 +3283 48 4299 4300 +3284 48 4299 4301 +3285 48 4302 4303 +3286 48 4302 4304 +3287 48 4305 4306 +3288 48 4305 4307 +3289 48 4308 4309 +3290 48 4308 4310 +3291 48 4311 4312 +3292 48 4311 4313 +3293 48 4314 4315 +3294 48 4314 4316 +3295 48 4317 4318 +3296 48 4317 4319 +3297 48 4320 4321 +3298 48 4320 4322 +3299 48 4323 4324 +3300 48 4323 4325 +3301 48 4326 4327 +3302 48 4326 4328 +3303 48 4329 4330 +3304 48 4329 4331 +3305 48 4332 4333 +3306 48 4332 4334 +3307 48 4335 4336 +3308 48 4335 4337 +3309 48 4338 4339 +3310 48 4338 4340 +3311 48 4341 4342 +3312 48 4341 4343 +3313 48 4344 4345 +3314 48 4344 4346 +3315 48 4347 4348 +3316 48 4347 4349 +3317 48 4350 4351 +3318 48 4350 4352 +3319 48 4353 4354 +3320 48 4353 4355 +3321 48 4356 4357 +3322 48 4356 4358 +3323 48 4359 4360 +3324 48 4359 4361 +3325 48 4362 4363 +3326 48 4362 4364 +3327 48 4365 4366 +3328 48 4365 4367 +3329 48 4368 4369 +3330 48 4368 4370 +3331 48 4371 4372 +3332 48 4371 4373 +3333 48 4374 4375 +3334 48 4374 4376 +3335 48 4377 4378 +3336 48 4377 4379 +3337 48 4380 4381 +3338 48 4380 4382 +3339 48 4383 4384 +3340 48 4383 4385 +3341 48 4386 4387 +3342 48 4386 4388 +3343 48 4389 4390 +3344 48 4389 4391 +3345 48 4392 4393 +3346 48 4392 4394 +3347 48 4395 4396 +3348 48 4395 4397 +3349 48 4398 4399 +3350 48 4398 4400 +3351 48 4401 4402 +3352 48 4401 4403 +3353 48 4404 4405 +3354 48 4404 4406 +3355 48 4407 4408 +3356 48 4407 4409 +3357 48 4410 4411 +3358 48 4410 4412 +3359 48 4413 4414 +3360 48 4413 4415 +3361 48 4416 4417 +3362 48 4416 4418 +3363 48 4419 4420 +3364 48 4419 4421 +3365 48 4422 4423 +3366 48 4422 4424 +3367 48 4425 4426 +3368 48 4425 4427 +3369 48 4428 4429 +3370 48 4428 4430 +3371 48 4431 4432 +3372 48 4431 4433 +3373 48 4434 4435 +3374 48 4434 4436 +3375 48 4437 4438 +3376 48 4437 4439 +3377 48 4440 4441 +3378 48 4440 4442 +3379 48 4443 4444 +3380 48 4443 4445 +3381 48 4446 4447 +3382 48 4446 4448 +3383 48 4449 4450 +3384 48 4449 4451 +3385 48 4452 4453 +3386 48 4452 4454 +3387 48 4455 4456 +3388 48 4455 4457 +3389 48 4458 4459 +3390 48 4458 4460 +3391 48 4461 4462 +3392 48 4461 4463 +3393 48 4464 4465 +3394 48 4464 4466 +3395 48 4467 4468 +3396 48 4467 4469 +3397 48 4470 4471 +3398 48 4470 4472 +3399 48 4473 4474 +3400 48 4473 4475 +3401 48 4476 4477 +3402 48 4476 4478 +3403 48 4479 4480 +3404 48 4479 4481 +3405 48 4482 4483 +3406 48 4482 4484 +3407 48 4485 4486 +3408 48 4485 4487 +3409 48 4488 4489 +3410 48 4488 4490 +3411 48 4491 4492 +3412 48 4491 4493 +3413 48 4494 4495 +3414 48 4494 4496 +3415 48 4497 4498 +3416 48 4497 4499 +3417 48 4500 4501 +3418 48 4500 4502 +3419 48 4503 4504 +3420 48 4503 4505 +3421 48 4506 4507 +3422 48 4506 4508 +3423 48 4509 4510 +3424 48 4509 4511 +3425 48 4512 4513 +3426 48 4512 4514 +3427 48 4515 4516 +3428 48 4515 4517 +3429 48 4518 4519 +3430 48 4518 4520 +3431 48 4521 4522 +3432 48 4521 4523 +3433 48 4524 4525 +3434 48 4524 4526 +3435 48 4527 4528 +3436 48 4527 4529 +3437 48 4530 4531 +3438 48 4530 4532 +3439 48 4533 4534 +3440 48 4533 4535 +3441 48 4536 4537 +3442 48 4536 4538 +3443 48 4539 4540 +3444 48 4539 4541 +3445 48 4542 4543 +3446 48 4542 4544 +3447 48 4545 4546 +3448 48 4545 4547 +3449 48 4548 4549 +3450 48 4548 4550 +3451 48 4551 4552 +3452 48 4551 4553 +3453 48 4554 4555 +3454 48 4554 4556 +3455 48 4557 4558 +3456 48 4557 4559 +3457 48 4560 4561 +3458 48 4560 4562 +3459 48 4563 4564 +3460 48 4563 4565 +3461 48 4566 4567 +3462 48 4566 4568 +3463 48 4569 4570 +3464 48 4569 4571 +3465 48 4572 4573 +3466 48 4572 4574 +3467 48 4575 4576 +3468 48 4575 4577 +3469 48 4578 4579 +3470 48 4578 4580 +3471 48 4581 4582 +3472 48 4581 4583 +3473 48 4584 4585 +3474 48 4584 4586 +3475 48 4587 4588 +3476 48 4587 4589 +3477 48 4590 4591 +3478 48 4590 4592 +3479 48 4593 4594 +3480 48 4593 4595 +3481 48 4596 4597 +3482 48 4596 4598 +3483 48 4599 4600 +3484 48 4599 4601 +3485 48 4602 4603 +3486 48 4602 4604 +3487 48 4605 4606 +3488 48 4605 4607 +3489 48 4608 4609 +3490 48 4608 4610 +3491 48 4611 4612 +3492 48 4611 4613 +3493 48 4614 4615 +3494 48 4614 4616 +3495 48 4617 4618 +3496 48 4617 4619 +3497 48 4620 4621 +3498 48 4620 4622 +3499 48 4623 4624 +3500 48 4623 4625 +3501 48 4626 4627 +3502 48 4626 4628 +3503 48 4629 4630 +3504 48 4629 4631 +3505 48 4632 4633 +3506 48 4632 4634 +3507 48 4635 4636 +3508 48 4635 4637 +3509 48 4638 4639 +3510 48 4638 4640 +3511 48 4641 4642 +3512 48 4641 4643 +3513 48 4644 4645 +3514 48 4644 4646 +3515 48 4647 4648 +3516 48 4647 4649 +3517 48 4650 4651 +3518 48 4650 4652 +3519 48 4653 4654 +3520 48 4653 4655 +3521 48 4656 4657 +3522 48 4656 4658 +3523 48 4659 4660 +3524 48 4659 4661 +3525 48 4662 4663 +3526 48 4662 4664 +3527 48 4665 4666 +3528 48 4665 4667 +3529 48 4668 4669 +3530 48 4668 4670 +3531 48 4671 4672 +3532 48 4671 4673 +3533 48 4674 4675 +3534 48 4674 4676 +3535 48 4677 4678 +3536 48 4677 4679 +3537 48 4680 4681 +3538 48 4680 4682 +3539 48 4683 4684 +3540 48 4683 4685 +3541 48 4686 4687 +3542 48 4686 4688 +3543 48 4689 4690 +3544 48 4689 4691 +3545 48 4692 4693 +3546 48 4692 4694 +3547 48 4695 4696 +3548 48 4695 4697 +3549 48 4698 4699 +3550 48 4698 4700 +3551 48 4701 4702 +3552 48 4701 4703 +3553 48 4704 4705 +3554 48 4704 4706 +3555 48 4707 4708 +3556 48 4707 4709 +3557 48 4710 4711 +3558 48 4710 4712 +3559 48 4713 4714 +3560 48 4713 4715 +3561 48 4716 4717 +3562 48 4716 4718 +3563 48 4719 4720 +3564 48 4719 4721 +3565 48 4722 4723 +3566 48 4722 4724 +3567 48 4725 4726 +3568 48 4725 4727 +3569 48 4728 4729 +3570 48 4728 4730 +3571 48 4731 4732 +3572 48 4731 4733 +3573 48 4734 4735 +3574 48 4734 4736 +3575 48 4737 4738 +3576 48 4737 4739 +3577 48 4740 4741 +3578 48 4740 4742 +3579 48 4743 4744 +3580 48 4743 4745 +3581 48 4746 4747 +3582 48 4746 4748 +3583 48 4749 4750 +3584 48 4749 4751 +3585 48 4752 4753 +3586 48 4752 4754 +3587 48 4755 4756 +3588 48 4755 4757 +3589 48 4758 4759 +3590 48 4758 4760 +3591 48 4761 4762 +3592 48 4761 4763 +3593 48 4764 4765 +3594 48 4764 4766 +3595 48 4767 4768 +3596 48 4767 4769 +3597 48 4770 4771 +3598 48 4770 4772 +3599 48 4773 4774 +3600 48 4773 4775 +3601 48 4776 4777 +3602 48 4776 4778 +3603 48 4779 4780 +3604 48 4779 4781 +3605 48 4782 4783 +3606 48 4782 4784 +3607 48 4785 4786 +3608 48 4785 4787 +3609 48 4788 4789 +3610 48 4788 4790 +3611 48 4791 4792 +3612 48 4791 4793 +3613 48 4794 4795 +3614 48 4794 4796 +3615 48 4797 4798 +3616 48 4797 4799 +3617 48 4800 4801 +3618 48 4800 4802 +3619 48 4803 4804 +3620 48 4803 4805 +3621 48 4806 4807 +3622 48 4806 4808 +3623 48 4809 4810 +3624 48 4809 4811 +3625 48 4812 4813 +3626 48 4812 4814 +3627 48 4815 4816 +3628 48 4815 4817 +3629 48 4818 4819 +3630 48 4818 4820 +3631 48 4821 4822 +3632 48 4821 4823 +3633 48 4824 4825 +3634 48 4824 4826 +3635 48 4827 4828 +3636 48 4827 4829 +3637 48 4830 4831 +3638 48 4830 4832 +3639 48 4833 4834 +3640 48 4833 4835 +3641 48 4836 4837 +3642 48 4836 4838 +3643 48 4839 4840 +3644 48 4839 4841 +3645 48 4842 4843 +3646 48 4842 4844 +3647 48 4845 4846 +3648 48 4845 4847 +3649 48 4848 4849 +3650 48 4848 4850 +3651 48 4851 4852 +3652 48 4851 4853 +3653 48 4854 4855 +3654 48 4854 4856 +3655 48 4857 4858 +3656 48 4857 4859 +3657 48 4860 4861 +3658 48 4860 4862 +3659 48 4863 4864 +3660 48 4863 4865 +3661 48 4866 4867 +3662 48 4866 4868 +3663 48 4869 4870 +3664 48 4869 4871 +3665 48 4872 4873 +3666 48 4872 4874 +3667 48 4875 4876 +3668 48 4875 4877 +3669 48 4878 4879 +3670 48 4878 4880 +3671 48 4881 4882 +3672 48 4881 4883 +3673 48 4884 4885 +3674 48 4884 4886 +3675 48 4887 4888 +3676 48 4887 4889 +3677 48 4890 4891 +3678 48 4890 4892 +3679 48 4893 4894 +3680 48 4893 4895 +3681 48 4896 4897 +3682 48 4896 4898 +3683 48 4899 4900 +3684 48 4899 4901 +3685 48 4902 4903 +3686 48 4902 4904 +3687 48 4905 4906 +3688 48 4905 4907 +3689 48 4908 4909 +3690 48 4908 4910 +3691 48 4911 4912 +3692 48 4911 4913 +3693 48 4914 4915 +3694 48 4914 4916 +3695 48 4917 4918 +3696 48 4917 4919 +3697 48 4920 4921 +3698 48 4920 4922 +3699 48 4923 4924 +3700 48 4923 4925 +3701 48 4926 4927 +3702 48 4926 4928 +3703 48 4929 4930 +3704 48 4929 4931 +3705 48 4932 4933 +3706 48 4932 4934 +3707 48 4935 4936 +3708 48 4935 4937 +3709 48 4938 4939 +3710 48 4938 4940 +3711 48 4941 4942 +3712 48 4941 4943 +3713 48 4944 4945 +3714 48 4944 4946 +3715 48 4947 4948 +3716 48 4947 4949 +3717 48 4950 4951 +3718 48 4950 4952 +3719 48 4953 4954 +3720 48 4953 4955 +3721 48 4956 4957 +3722 48 4956 4958 +3723 48 4959 4960 +3724 48 4959 4961 +3725 48 4962 4963 +3726 48 4962 4964 +3727 48 4965 4966 +3728 48 4965 4967 +3729 48 4968 4969 +3730 48 4968 4970 +3731 48 4971 4972 +3732 48 4971 4973 +3733 48 4974 4975 +3734 48 4974 4976 +3735 48 4977 4978 +3736 48 4977 4979 +3737 48 4980 4981 +3738 48 4980 4982 +3739 48 4983 4984 +3740 48 4983 4985 +3741 48 4986 4987 +3742 48 4986 4988 +3743 48 4989 4990 +3744 48 4989 4991 +3745 48 4992 4993 +3746 48 4992 4994 +3747 48 4995 4996 +3748 48 4995 4997 +3749 48 4998 4999 +3750 48 4998 5000 +3751 48 5001 5002 +3752 48 5001 5003 +3753 48 5004 5005 +3754 48 5004 5006 +3755 48 5007 5008 +3756 48 5007 5009 +3757 48 5010 5011 +3758 48 5010 5012 +3759 48 5013 5014 +3760 48 5013 5015 +3761 48 5016 5017 +3762 48 5016 5018 +3763 48 5019 5020 +3764 48 5019 5021 +3765 48 5022 5023 +3766 48 5022 5024 +3767 48 5025 5026 +3768 48 5025 5027 +3769 48 5028 5029 +3770 48 5028 5030 +3771 48 5031 5032 +3772 48 5031 5033 +3773 48 5034 5035 +3774 48 5034 5036 +3775 48 5037 5038 +3776 48 5037 5039 +3777 48 5040 5041 +3778 48 5040 5042 +3779 48 5043 5044 +3780 48 5043 5045 +3781 48 5046 5047 +3782 48 5046 5048 +3783 48 5049 5050 +3784 48 5049 5051 +3785 48 5052 5053 +3786 48 5052 5054 +3787 48 5055 5056 +3788 48 5055 5057 +3789 48 5058 5059 +3790 48 5058 5060 +3791 48 5061 5062 +3792 48 5061 5063 +3793 48 5064 5065 +3794 48 5064 5066 +3795 48 5067 5068 +3796 48 5067 5069 +3797 48 5070 5071 +3798 48 5070 5072 +3799 48 5073 5074 +3800 48 5073 5075 +3801 48 5076 5077 +3802 48 5076 5078 +3803 48 5079 5080 +3804 48 5079 5081 +3805 48 5082 5083 +3806 48 5082 5084 +3807 48 5085 5086 +3808 48 5085 5087 +3809 48 5088 5089 +3810 48 5088 5090 +3811 48 5091 5092 +3812 48 5091 5093 +3813 48 5094 5095 +3814 48 5094 5096 +3815 48 5097 5098 +3816 48 5097 5099 +3817 48 5100 5101 +3818 48 5100 5102 +3819 48 5103 5104 +3820 48 5103 5105 +3821 48 5106 5107 +3822 48 5106 5108 +3823 48 5109 5110 +3824 48 5109 5111 +3825 48 5112 5113 +3826 48 5112 5114 +3827 48 5115 5116 +3828 48 5115 5117 +3829 48 5118 5119 +3830 48 5118 5120 +3831 48 5121 5122 +3832 48 5121 5123 +3833 48 5124 5125 +3834 48 5124 5126 +3835 48 5127 5128 +3836 48 5127 5129 +3837 48 5130 5131 +3838 48 5130 5132 +3839 48 5133 5134 +3840 48 5133 5135 +3841 48 5136 5137 +3842 48 5136 5138 +3843 48 5139 5140 +3844 48 5139 5141 +3845 48 5142 5143 +3846 48 5142 5144 +3847 48 5145 5146 +3848 48 5145 5147 +3849 48 5148 5149 +3850 48 5148 5150 +3851 48 5151 5152 +3852 48 5151 5153 +3853 48 5154 5155 +3854 48 5154 5156 +3855 48 5157 5158 +3856 48 5157 5159 +3857 48 5160 5161 +3858 48 5160 5162 +3859 48 5163 5164 +3860 48 5163 5165 +3861 48 5166 5167 +3862 48 5166 5168 +3863 48 5169 5170 +3864 48 5169 5171 +3865 48 5172 5173 +3866 48 5172 5174 +3867 48 5175 5176 +3868 48 5175 5177 +3869 48 5178 5179 +3870 48 5178 5180 +3871 48 5181 5182 +3872 48 5181 5183 +3873 48 5184 5185 +3874 48 5184 5186 +3875 48 5187 5188 +3876 48 5187 5189 +3877 48 5190 5191 +3878 48 5190 5192 +3879 48 5193 5194 +3880 48 5193 5195 +3881 48 5196 5197 +3882 48 5196 5198 +3883 48 5199 5200 +3884 48 5199 5201 +3885 48 5202 5203 +3886 48 5202 5204 +3887 48 5205 5206 +3888 48 5205 5207 +3889 48 5208 5209 +3890 48 5208 5210 +3891 48 5211 5212 +3892 48 5211 5213 +3893 48 5214 5215 +3894 48 5214 5216 +3895 48 5217 5218 +3896 48 5217 5219 +3897 48 5220 5221 +3898 48 5220 5222 +3899 48 5223 5224 +3900 48 5223 5225 +3901 48 5226 5227 +3902 48 5226 5228 +3903 48 5229 5230 +3904 48 5229 5231 +3905 48 5232 5233 +3906 48 5232 5234 +3907 48 5235 5236 +3908 48 5235 5237 +3909 48 5238 5239 +3910 48 5238 5240 +3911 48 5241 5242 +3912 48 5241 5243 +3913 48 5244 5245 +3914 48 5244 5246 +3915 48 5247 5248 +3916 48 5247 5249 +3917 48 5250 5251 +3918 48 5250 5252 +3919 48 5253 5254 +3920 48 5253 5255 +3921 48 5256 5257 +3922 48 5256 5258 +3923 48 5259 5260 +3924 48 5259 5261 +3925 48 5262 5263 +3926 48 5262 5264 +3927 48 5265 5266 +3928 48 5265 5267 +3929 48 5268 5269 +3930 48 5268 5270 +3931 48 5271 5272 +3932 48 5271 5273 +3933 48 5274 5275 +3934 48 5274 5276 +3935 48 5277 5278 +3936 48 5277 5279 +3937 48 5280 5281 +3938 48 5280 5282 +3939 48 5283 5284 +3940 48 5283 5285 +3941 48 5286 5287 +3942 48 5286 5288 +3943 48 5289 5290 +3944 48 5289 5291 +3945 48 5292 5293 +3946 48 5292 5294 +3947 48 5295 5296 +3948 48 5295 5297 +3949 48 5298 5299 +3950 48 5298 5300 +3951 48 5301 5302 +3952 48 5301 5303 +3953 48 5304 5305 +3954 48 5304 5306 +3955 48 5307 5308 +3956 48 5307 5309 +3957 48 5310 5311 +3958 48 5310 5312 +3959 48 5313 5314 +3960 48 5313 5315 +3961 48 5316 5317 +3962 48 5316 5318 +3963 48 5319 5320 +3964 48 5319 5321 +3965 48 5322 5323 +3966 48 5322 5324 +3967 48 5325 5326 +3968 48 5325 5327 +3969 48 5328 5329 +3970 48 5328 5330 +3971 48 5331 5332 +3972 48 5331 5333 +3973 48 5334 5335 +3974 48 5334 5336 +3975 48 5337 5338 +3976 48 5337 5339 +3977 48 5340 5341 +3978 48 5340 5342 +3979 48 5343 5344 +3980 48 5343 5345 +3981 48 5346 5347 +3982 48 5346 5348 +3983 48 5349 5350 +3984 48 5349 5351 +3985 48 5352 5353 +3986 48 5352 5354 +3987 48 5355 5356 +3988 48 5355 5357 +3989 48 5358 5359 +3990 48 5358 5360 +3991 48 5361 5362 +3992 48 5361 5363 +3993 48 5364 5365 +3994 48 5364 5366 +3995 48 5367 5368 +3996 48 5367 5369 +3997 48 5370 5371 +3998 48 5370 5372 +3999 48 5373 5374 +4000 48 5373 5375 +4001 48 5376 5377 +4002 48 5376 5378 +4003 48 5379 5380 +4004 48 5379 5381 +4005 48 5382 5383 +4006 48 5382 5384 +4007 48 5385 5386 +4008 48 5385 5387 +4009 48 5388 5389 +4010 48 5388 5390 +4011 48 5391 5392 +4012 48 5391 5393 +4013 48 5394 5395 +4014 48 5394 5396 +4015 48 5397 5398 +4016 48 5397 5399 +4017 48 5400 5401 +4018 48 5400 5402 +4019 48 5403 5404 +4020 48 5403 5405 +4021 48 5406 5407 +4022 48 5406 5408 +4023 48 5409 5410 +4024 48 5409 5411 +4025 48 5412 5413 +4026 48 5412 5414 +4027 48 5415 5416 +4028 48 5415 5417 +4029 48 5418 5419 +4030 48 5418 5420 +4031 48 5421 5422 +4032 48 5421 5423 +4033 48 5424 5425 +4034 48 5424 5426 +4035 48 5427 5428 +4036 48 5427 5429 +4037 48 5430 5431 +4038 48 5430 5432 +4039 48 5433 5434 +4040 48 5433 5435 +4041 48 5436 5437 +4042 48 5436 5438 +4043 48 5439 5440 +4044 48 5439 5441 +4045 48 5442 5443 +4046 48 5442 5444 +4047 48 5445 5446 +4048 48 5445 5447 +4049 48 5448 5449 +4050 48 5448 5450 +4051 48 5451 5452 +4052 48 5451 5453 +4053 48 5454 5455 +4054 48 5454 5456 +4055 48 5457 5458 +4056 48 5457 5459 +4057 48 5460 5461 +4058 48 5460 5462 +4059 48 5463 5464 +4060 48 5463 5465 +4061 48 5466 5467 +4062 48 5466 5468 +4063 48 5469 5470 +4064 48 5469 5471 +4065 48 5472 5473 +4066 48 5472 5474 +4067 48 5475 5476 +4068 48 5475 5477 +4069 48 5478 5479 +4070 48 5478 5480 +4071 48 5481 5482 +4072 48 5481 5483 +4073 48 5484 5485 +4074 48 5484 5486 +4075 48 5487 5488 +4076 48 5487 5489 +4077 48 5490 5491 +4078 48 5490 5492 +4079 48 5493 5494 +4080 48 5493 5495 +4081 48 5496 5497 +4082 48 5496 5498 +4083 48 5499 5500 +4084 48 5499 5501 +4085 48 5502 5503 +4086 48 5502 5504 +4087 48 5505 5506 +4088 48 5505 5507 +4089 48 5508 5509 +4090 48 5508 5510 +4091 48 5511 5512 +4092 48 5511 5513 +4093 48 5514 5515 +4094 48 5514 5516 +4095 48 5517 5518 +4096 48 5517 5519 +4097 48 5520 5521 +4098 48 5520 5522 +4099 48 5523 5524 +4100 48 5523 5525 +4101 48 5526 5527 +4102 48 5526 5528 +4103 48 5529 5530 +4104 48 5529 5531 +4105 48 5532 5533 +4106 48 5532 5534 +4107 48 5535 5536 +4108 48 5535 5537 +4109 48 5538 5539 +4110 48 5538 5540 +4111 48 5541 5542 +4112 48 5541 5543 +4113 48 5544 5545 +4114 48 5544 5546 +4115 48 5547 5548 +4116 48 5547 5549 +4117 48 5550 5551 +4118 48 5550 5552 +4119 48 5553 5554 +4120 48 5553 5555 +4121 48 5556 5557 +4122 48 5556 5558 +4123 48 5559 5560 +4124 48 5559 5561 +4125 48 5562 5563 +4126 48 5562 5564 +4127 48 5565 5566 +4128 48 5565 5567 +4129 48 5568 5569 +4130 48 5568 5570 +4131 48 5571 5572 +4132 48 5571 5573 +4133 48 5574 5575 +4134 48 5574 5576 +4135 48 5577 5578 +4136 48 5577 5579 +4137 48 5580 5581 +4138 48 5580 5582 +4139 48 5583 5584 +4140 48 5583 5585 +4141 48 5586 5587 +4142 48 5586 5588 +4143 48 5589 5590 +4144 48 5589 5591 +4145 48 5592 5593 +4146 48 5592 5594 +4147 48 5595 5596 +4148 48 5595 5597 +4149 48 5598 5599 +4150 48 5598 5600 +4151 48 5601 5602 +4152 48 5601 5603 +4153 48 5604 5605 +4154 48 5604 5606 +4155 48 5607 5608 +4156 48 5607 5609 +4157 48 5610 5611 +4158 48 5610 5612 +4159 48 5613 5614 +4160 48 5613 5615 +4161 48 5616 5617 +4162 48 5616 5618 +4163 48 5619 5620 +4164 48 5619 5621 +4165 48 5622 5623 +4166 48 5622 5624 +4167 48 5625 5626 +4168 48 5625 5627 +4169 48 5628 5629 +4170 48 5628 5630 +4171 48 5631 5632 +4172 48 5631 5633 +4173 48 5634 5635 +4174 48 5634 5636 +4175 48 5637 5638 +4176 48 5637 5639 +4177 48 5640 5641 +4178 48 5640 5642 +4179 48 5643 5644 +4180 48 5643 5645 +4181 48 5646 5647 +4182 48 5646 5648 +4183 48 5649 5650 +4184 48 5649 5651 +4185 48 5652 5653 +4186 48 5652 5654 +4187 48 5655 5656 +4188 48 5655 5657 +4189 48 5658 5659 +4190 48 5658 5660 +4191 48 5661 5662 +4192 48 5661 5663 +4193 48 5664 5665 +4194 48 5664 5666 +4195 48 5667 5668 +4196 48 5667 5669 +4197 48 5670 5671 +4198 48 5670 5672 +4199 48 5673 5674 +4200 48 5673 5675 +4201 48 5676 5677 +4202 48 5676 5678 +4203 48 5679 5680 +4204 48 5679 5681 +4205 48 5682 5683 +4206 48 5682 5684 +4207 48 5685 5686 +4208 48 5685 5687 +4209 48 5688 5689 +4210 48 5688 5690 +4211 48 5691 5692 +4212 48 5691 5693 +4213 48 5694 5695 +4214 48 5694 5696 +4215 48 5697 5698 +4216 48 5697 5699 +4217 48 5700 5701 +4218 48 5700 5702 +4219 48 5703 5704 +4220 48 5703 5705 +4221 48 5706 5707 +4222 48 5706 5708 +4223 48 5709 5710 +4224 48 5709 5711 +4225 48 5712 5713 +4226 48 5712 5714 +4227 48 5715 5716 +4228 48 5715 5717 +4229 48 5718 5719 +4230 48 5718 5720 +4231 48 5721 5722 +4232 48 5721 5723 +4233 48 5724 5725 +4234 48 5724 5726 +4235 48 5727 5728 +4236 48 5727 5729 +4237 48 5730 5731 +4238 48 5730 5732 +4239 48 5733 5734 +4240 48 5733 5735 +4241 48 5736 5737 +4242 48 5736 5738 +4243 48 5739 5740 +4244 48 5739 5741 +4245 48 5742 5743 +4246 48 5742 5744 +4247 48 5745 5746 +4248 48 5745 5747 +4249 48 5748 5749 +4250 48 5748 5750 +4251 48 5751 5752 +4252 48 5751 5753 +4253 48 5754 5755 +4254 48 5754 5756 +4255 48 5757 5758 +4256 48 5757 5759 +4257 48 5760 5761 +4258 48 5760 5762 +4259 48 5763 5764 +4260 48 5763 5765 +4261 48 5766 5767 +4262 48 5766 5768 +4263 48 5769 5770 +4264 48 5769 5771 +4265 48 5772 5773 +4266 48 5772 5774 +4267 48 5775 5776 +4268 48 5775 5777 +4269 48 5778 5779 +4270 48 5778 5780 +4271 48 5781 5782 +4272 48 5781 5783 +4273 48 5784 5785 +4274 48 5784 5786 +4275 48 5787 5788 +4276 48 5787 5789 +4277 48 5790 5791 +4278 48 5790 5792 +4279 48 5793 5794 +4280 48 5793 5795 +4281 48 5796 5797 +4282 48 5796 5798 +4283 48 5799 5800 +4284 48 5799 5801 +4285 48 5802 5803 +4286 48 5802 5804 +4287 48 5805 5806 +4288 48 5805 5807 +4289 48 5808 5809 +4290 48 5808 5810 +4291 48 5811 5812 +4292 48 5811 5813 +4293 48 5814 5815 +4294 48 5814 5816 +4295 48 5817 5818 +4296 48 5817 5819 +4297 48 5820 5821 +4298 48 5820 5822 +4299 48 5823 5824 +4300 48 5823 5825 +4301 48 5826 5827 +4302 48 5826 5828 +4303 48 5829 5830 +4304 48 5829 5831 +4305 48 5832 5833 +4306 48 5832 5834 +4307 48 5835 5836 +4308 48 5835 5837 +4309 48 5838 5839 +4310 48 5838 5840 +4311 48 5841 5842 +4312 48 5841 5843 +4313 48 5844 5845 +4314 48 5844 5846 +4315 48 5847 5848 +4316 48 5847 5849 +4317 48 5850 5851 +4318 48 5850 5852 +4319 48 5853 5854 +4320 48 5853 5855 +4321 48 5856 5857 +4322 48 5856 5858 +4323 48 5859 5860 +4324 48 5859 5861 +4325 48 5862 5863 +4326 48 5862 5864 +4327 48 5865 5866 +4328 48 5865 5867 +4329 48 5868 5869 +4330 48 5868 5870 +4331 48 5871 5872 +4332 48 5871 5873 +4333 48 5874 5875 +4334 48 5874 5876 +4335 48 5877 5878 +4336 48 5877 5879 +4337 48 5880 5881 +4338 48 5880 5882 +4339 48 5883 5884 +4340 48 5883 5885 +4341 48 5886 5887 +4342 48 5886 5888 +4343 48 5889 5890 +4344 48 5889 5891 +4345 48 5892 5893 +4346 48 5892 5894 +4347 48 5895 5896 +4348 48 5895 5897 +4349 48 5898 5899 +4350 48 5898 5900 +4351 48 5901 5902 +4352 48 5901 5903 +4353 48 5904 5905 +4354 48 5904 5906 +4355 48 5907 5908 +4356 48 5907 5909 +4357 48 5910 5911 +4358 48 5910 5912 +4359 48 5913 5914 +4360 48 5913 5915 +4361 48 5916 5917 +4362 48 5916 5918 +4363 48 5919 5920 +4364 48 5919 5921 +4365 48 5922 5923 +4366 48 5922 5924 +4367 48 5925 5926 +4368 48 5925 5927 +4369 48 5928 5929 +4370 48 5928 5930 +4371 48 5931 5932 +4372 48 5931 5933 +4373 48 5934 5935 +4374 48 5934 5936 +4375 48 5937 5938 +4376 48 5937 5939 +4377 48 5940 5941 +4378 48 5940 5942 +4379 48 5943 5944 +4380 48 5943 5945 +4381 48 5946 5947 +4382 48 5946 5948 +4383 48 5949 5950 +4384 48 5949 5951 +4385 48 5952 5953 +4386 48 5952 5954 +4387 48 5955 5956 +4388 48 5955 5957 +4389 48 5958 5959 +4390 48 5958 5960 +4391 48 5961 5962 +4392 48 5961 5963 +4393 48 5964 5965 +4394 48 5964 5966 +4395 48 5967 5968 +4396 48 5967 5969 +4397 48 5970 5971 +4398 48 5970 5972 +4399 48 5973 5974 +4400 48 5973 5975 +4401 48 5976 5977 +4402 48 5976 5978 +4403 48 5979 5980 +4404 48 5979 5981 +4405 48 5982 5983 +4406 48 5982 5984 +4407 48 5985 5986 +4408 48 5985 5987 +4409 48 5988 5989 +4410 48 5988 5990 +4411 48 5991 5992 +4412 48 5991 5993 +4413 48 5994 5995 +4414 48 5994 5996 +4415 48 5997 5998 +4416 48 5997 5999 +4417 48 6000 6001 +4418 48 6000 6002 +4419 48 6003 6004 +4420 48 6003 6005 +4421 48 6006 6007 +4422 48 6006 6008 +4423 48 6009 6010 +4424 48 6009 6011 +4425 48 6012 6013 +4426 48 6012 6014 +4427 48 6015 6016 +4428 48 6015 6017 +4429 48 6018 6019 +4430 48 6018 6020 +4431 48 6021 6022 +4432 48 6021 6023 +4433 48 6024 6025 +4434 48 6024 6026 +4435 48 6027 6028 +4436 48 6027 6029 +4437 48 6030 6031 +4438 48 6030 6032 +4439 48 6033 6034 +4440 48 6033 6035 +4441 48 6036 6037 +4442 48 6036 6038 +4443 48 6039 6040 +4444 48 6039 6041 +4445 48 6042 6043 +4446 48 6042 6044 +4447 48 6045 6046 +4448 48 6045 6047 +4449 48 6048 6049 +4450 48 6048 6050 +4451 48 6051 6052 +4452 48 6051 6053 +4453 48 6054 6055 +4454 48 6054 6056 +4455 48 6057 6058 +4456 48 6057 6059 +4457 48 6060 6061 +4458 48 6060 6062 +4459 48 6063 6064 +4460 48 6063 6065 +4461 48 6066 6067 +4462 48 6066 6068 +4463 48 6069 6070 +4464 48 6069 6071 +4465 48 6072 6073 +4466 48 6072 6074 +4467 48 6075 6076 +4468 48 6075 6077 +4469 48 6078 6079 +4470 48 6078 6080 +4471 48 6081 6082 +4472 48 6081 6083 +4473 48 6084 6085 +4474 48 6084 6086 +4475 48 6087 6088 +4476 48 6087 6089 +4477 48 6090 6091 +4478 48 6090 6092 +4479 48 6093 6094 +4480 48 6093 6095 +4481 48 6096 6097 +4482 48 6096 6098 +4483 48 6099 6100 +4484 48 6099 6101 +4485 48 6102 6103 +4486 48 6102 6104 +4487 48 6105 6106 +4488 48 6105 6107 +4489 48 6108 6109 +4490 48 6108 6110 +4491 48 6111 6112 +4492 48 6111 6113 +4493 48 6114 6115 +4494 48 6114 6116 +4495 48 6117 6118 +4496 48 6117 6119 +4497 48 6120 6121 +4498 48 6120 6122 +4499 48 6123 6124 +4500 48 6123 6125 +4501 48 6126 6127 +4502 48 6126 6128 +4503 48 6129 6130 +4504 48 6129 6131 +4505 48 6132 6133 +4506 48 6132 6134 +4507 48 6135 6136 +4508 48 6135 6137 +4509 48 6138 6139 +4510 48 6138 6140 +4511 48 6141 6142 +4512 48 6141 6143 +4513 48 6144 6145 +4514 48 6144 6146 +4515 48 6147 6148 +4516 48 6147 6149 +4517 48 6150 6151 +4518 48 6150 6152 +4519 48 6153 6154 +4520 48 6153 6155 +4521 48 6156 6157 +4522 48 6156 6158 +4523 48 6159 6160 +4524 48 6159 6161 +4525 48 6162 6163 +4526 48 6162 6164 +4527 48 6165 6166 +4528 48 6165 6167 +4529 48 6168 6169 +4530 48 6168 6170 +4531 48 6171 6172 +4532 48 6171 6173 +4533 48 6174 6175 +4534 48 6174 6176 +4535 48 6177 6178 +4536 48 6177 6179 +4537 48 6180 6181 +4538 48 6180 6182 +4539 48 6183 6184 +4540 48 6183 6185 +4541 48 6186 6187 +4542 48 6186 6188 +4543 48 6189 6190 +4544 48 6189 6191 +4545 48 6192 6193 +4546 48 6192 6194 +4547 48 6195 6196 +4548 48 6195 6197 +4549 48 6198 6199 +4550 48 6198 6200 +4551 48 6201 6202 +4552 48 6201 6203 +4553 48 6204 6205 +4554 48 6204 6206 +4555 48 6207 6208 +4556 48 6207 6209 +4557 48 6210 6211 +4558 48 6210 6212 +4559 48 6213 6214 +4560 48 6213 6215 +4561 48 6216 6217 +4562 48 6216 6218 +4563 48 6219 6220 +4564 48 6219 6221 +4565 48 6222 6223 +4566 48 6222 6224 +4567 48 6225 6226 +4568 48 6225 6227 +4569 48 6228 6229 +4570 48 6228 6230 +4571 48 6231 6232 +4572 48 6231 6233 +4573 48 6234 6235 +4574 48 6234 6236 +4575 48 6237 6238 +4576 48 6237 6239 +4577 48 6240 6241 +4578 48 6240 6242 +4579 48 6243 6244 +4580 48 6243 6245 +4581 48 6246 6247 +4582 48 6246 6248 +4583 48 6249 6250 +4584 48 6249 6251 +4585 48 6252 6253 +4586 48 6252 6254 +4587 48 6255 6256 +4588 48 6255 6257 +4589 48 6258 6259 +4590 48 6258 6260 +4591 48 6261 6262 +4592 48 6261 6263 +4593 48 6264 6265 +4594 48 6264 6266 +4595 48 6267 6268 +4596 48 6267 6269 +4597 48 6270 6271 +4598 48 6270 6272 +4599 48 6273 6274 +4600 48 6273 6275 +4601 48 6276 6277 +4602 48 6276 6278 +4603 48 6279 6280 +4604 48 6279 6281 +4605 48 6282 6283 +4606 48 6282 6284 +4607 48 6285 6286 +4608 48 6285 6287 +4609 48 6288 6289 +4610 48 6288 6290 +4611 48 6291 6292 +4612 48 6291 6293 +4613 48 6294 6295 +4614 48 6294 6296 +4615 48 6297 6298 +4616 48 6297 6299 +4617 48 6300 6301 +4618 48 6300 6302 +4619 48 6303 6304 +4620 48 6303 6305 +4621 48 6306 6307 +4622 48 6306 6308 +4623 48 6309 6310 +4624 48 6309 6311 +4625 48 6312 6313 +4626 48 6312 6314 +4627 48 6315 6316 +4628 48 6315 6317 +4629 48 6318 6319 +4630 48 6318 6320 +4631 48 6321 6322 +4632 48 6321 6323 +4633 48 6324 6325 +4634 48 6324 6326 +4635 48 6327 6328 +4636 48 6327 6329 +4637 48 6330 6331 +4638 48 6330 6332 +4639 48 6333 6334 +4640 48 6333 6335 +4641 48 6336 6337 +4642 48 6336 6338 +4643 48 6339 6340 +4644 48 6339 6341 +4645 48 6342 6343 +4646 48 6342 6344 +4647 48 6345 6346 +4648 48 6345 6347 +4649 48 6348 6349 +4650 48 6348 6350 +4651 48 6351 6352 +4652 48 6351 6353 +4653 48 6354 6355 +4654 48 6354 6356 +4655 48 6357 6358 +4656 48 6357 6359 +4657 48 6360 6361 +4658 48 6360 6362 +4659 48 6363 6364 +4660 48 6363 6365 +4661 48 6366 6367 +4662 48 6366 6368 +4663 48 6369 6370 +4664 48 6369 6371 +4665 48 6372 6373 +4666 48 6372 6374 +4667 48 6375 6376 +4668 48 6375 6377 +4669 48 6378 6379 +4670 48 6378 6380 +4671 48 6381 6382 +4672 48 6381 6383 +4673 48 6384 6385 +4674 48 6384 6386 +4675 48 6387 6388 +4676 48 6387 6389 +4677 48 6390 6391 +4678 48 6390 6392 +4679 48 6393 6394 +4680 48 6393 6395 +4681 48 6396 6397 +4682 48 6396 6398 +4683 48 6399 6400 +4684 48 6399 6401 +4685 48 6402 6403 +4686 48 6402 6404 +4687 48 6405 6406 +4688 48 6405 6407 +4689 48 6408 6409 +4690 48 6408 6410 +4691 48 6411 6412 +4692 48 6411 6413 +4693 48 6414 6415 +4694 48 6414 6416 +4695 48 6417 6418 +4696 48 6417 6419 +4697 48 6420 6421 +4698 48 6420 6422 +4699 48 6423 6424 +4700 48 6423 6425 +4701 48 6426 6427 +4702 48 6426 6428 +4703 48 6429 6430 +4704 48 6429 6431 +4705 48 6432 6433 +4706 48 6432 6434 +4707 48 6435 6436 +4708 48 6435 6437 +4709 48 6438 6439 +4710 48 6438 6440 +4711 48 6441 6442 +4712 48 6441 6443 +4713 48 6444 6445 +4714 48 6444 6446 +4715 48 6447 6448 +4716 48 6447 6449 +4717 48 6450 6451 +4718 48 6450 6452 +4719 48 6453 6454 +4720 48 6453 6455 +4721 48 6456 6457 +4722 48 6456 6458 +4723 48 6459 6460 +4724 48 6459 6461 +4725 48 6462 6463 +4726 48 6462 6464 +4727 48 6465 6466 +4728 48 6465 6467 +4729 48 6468 6469 +4730 48 6468 6470 +4731 48 6471 6472 +4732 48 6471 6473 +4733 48 6474 6475 +4734 48 6474 6476 +4735 48 6477 6478 +4736 48 6477 6479 +4737 48 6480 6481 +4738 48 6480 6482 +4739 48 6483 6484 +4740 48 6483 6485 +4741 48 6486 6487 +4742 48 6486 6488 +4743 48 6489 6490 +4744 48 6489 6491 +4745 48 6492 6493 +4746 48 6492 6494 +4747 48 6495 6496 +4748 48 6495 6497 +4749 48 6498 6499 +4750 48 6498 6500 +4751 48 6501 6502 +4752 48 6501 6503 +4753 48 6504 6505 +4754 48 6504 6506 +4755 48 6507 6508 +4756 48 6507 6509 +4757 48 6510 6511 +4758 48 6510 6512 +4759 48 6513 6514 +4760 48 6513 6515 +4761 48 6516 6517 +4762 48 6516 6518 +4763 48 6519 6520 +4764 48 6519 6521 +4765 48 6522 6523 +4766 48 6522 6524 +4767 48 6525 6526 +4768 48 6525 6527 +4769 48 6528 6529 +4770 48 6528 6530 +4771 48 6531 6532 +4772 48 6531 6533 +4773 48 6534 6535 +4774 48 6534 6536 +4775 48 6537 6538 +4776 48 6537 6539 +4777 48 6540 6541 +4778 48 6540 6542 +4779 48 6543 6544 +4780 48 6543 6545 +4781 48 6546 6547 +4782 48 6546 6548 +4783 48 6549 6550 +4784 48 6549 6551 +4785 48 6552 6553 +4786 48 6552 6554 +4787 48 6555 6556 +4788 48 6555 6557 +4789 48 6558 6559 +4790 48 6558 6560 +4791 48 6561 6562 +4792 48 6561 6563 +4793 48 6564 6565 +4794 48 6564 6566 +4795 48 6567 6568 +4796 48 6567 6569 +4797 48 6570 6571 +4798 48 6570 6572 +4799 48 6573 6574 +4800 48 6573 6575 +4801 48 6576 6577 +4802 48 6576 6578 +4803 48 6579 6580 +4804 48 6579 6581 +4805 48 6582 6583 +4806 48 6582 6584 +4807 48 6585 6586 +4808 48 6585 6587 +4809 48 6588 6589 +4810 48 6588 6590 +4811 48 6591 6592 +4812 48 6591 6593 +4813 48 6594 6595 +4814 48 6594 6596 +4815 48 6597 6598 +4816 48 6597 6599 +4817 48 6600 6601 +4818 48 6600 6602 +4819 48 6603 6604 +4820 48 6603 6605 +4821 48 6606 6607 +4822 48 6606 6608 +4823 48 6609 6610 +4824 48 6609 6611 +4825 48 6612 6613 +4826 48 6612 6614 +4827 48 6615 6616 +4828 48 6615 6617 +4829 48 6618 6619 +4830 48 6618 6620 +4831 48 6621 6622 +4832 48 6621 6623 +4833 48 6624 6625 +4834 48 6624 6626 +4835 48 6627 6628 +4836 48 6627 6629 +4837 48 6630 6631 +4838 48 6630 6632 +4839 48 6633 6634 +4840 48 6633 6635 +4841 48 6636 6637 +4842 48 6636 6638 +4843 48 6639 6640 +4844 48 6639 6641 +4845 48 6642 6643 +4846 48 6642 6644 +4847 48 6645 6646 +4848 48 6645 6647 +4849 48 6648 6649 +4850 48 6648 6650 +4851 48 6651 6652 +4852 48 6651 6653 +4853 48 6654 6655 +4854 48 6654 6656 +4855 48 6657 6658 +4856 48 6657 6659 +4857 48 6660 6661 +4858 48 6660 6662 +4859 48 6663 6664 +4860 48 6663 6665 +4861 48 6666 6667 +4862 48 6666 6668 +4863 48 6669 6670 +4864 48 6669 6671 +4865 48 6672 6673 +4866 48 6672 6674 +4867 48 6675 6676 +4868 48 6675 6677 +4869 48 6678 6679 +4870 48 6678 6680 +4871 48 6681 6682 +4872 48 6681 6683 +4873 48 6684 6685 +4874 48 6684 6686 +4875 48 6687 6688 +4876 48 6687 6689 +4877 48 6690 6691 +4878 48 6690 6692 +4879 48 6693 6694 +4880 48 6693 6695 +4881 48 6696 6697 +4882 48 6696 6698 +4883 48 6699 6700 +4884 48 6699 6701 +4885 48 6702 6703 +4886 48 6702 6704 +4887 48 6705 6706 +4888 48 6705 6707 +4889 48 6708 6709 +4890 48 6708 6710 +4891 48 6711 6712 +4892 48 6711 6713 +4893 48 6714 6715 +4894 48 6714 6716 +4895 48 6717 6718 +4896 48 6717 6719 +4897 48 6720 6721 +4898 48 6720 6722 +4899 48 6723 6724 +4900 48 6723 6725 +4901 48 6726 6727 +4902 48 6726 6728 +4903 48 6729 6730 +4904 48 6729 6731 +4905 48 6732 6733 +4906 48 6732 6734 +4907 48 6735 6736 +4908 48 6735 6737 +4909 48 6738 6739 +4910 48 6738 6740 +4911 48 6741 6742 +4912 48 6741 6743 +4913 48 6744 6745 +4914 48 6744 6746 +4915 48 6747 6748 +4916 48 6747 6749 +4917 48 6750 6751 +4918 48 6750 6752 +4919 48 6753 6754 +4920 48 6753 6755 +4921 48 6756 6757 +4922 48 6756 6758 +4923 48 6759 6760 +4924 48 6759 6761 +4925 48 6762 6763 +4926 48 6762 6764 +4927 48 6765 6766 +4928 48 6765 6767 +4929 48 6768 6769 +4930 48 6768 6770 +4931 48 6771 6772 +4932 48 6771 6773 +4933 48 6774 6775 +4934 48 6774 6776 +4935 48 6777 6778 +4936 48 6777 6779 +4937 48 6780 6781 +4938 48 6780 6782 +4939 48 6783 6784 +4940 48 6783 6785 +4941 48 6786 6787 +4942 48 6786 6788 +4943 48 6789 6790 +4944 48 6789 6791 +4945 48 6792 6793 +4946 48 6792 6794 +4947 48 6795 6796 +4948 48 6795 6797 +4949 48 6798 6799 +4950 48 6798 6800 +4951 48 6801 6802 +4952 48 6801 6803 +4953 48 6804 6805 +4954 48 6804 6806 +4955 48 6807 6808 +4956 48 6807 6809 +4957 48 6810 6811 +4958 48 6810 6812 +4959 48 6813 6814 +4960 48 6813 6815 +4961 48 6816 6817 +4962 48 6816 6818 +4963 48 6819 6820 +4964 48 6819 6821 +4965 48 6822 6823 +4966 48 6822 6824 +4967 48 6825 6826 +4968 48 6825 6827 +4969 48 6828 6829 +4970 48 6828 6830 +4971 48 6831 6832 +4972 48 6831 6833 +4973 48 6834 6835 +4974 48 6834 6836 +4975 48 6837 6838 +4976 48 6837 6839 +4977 48 6840 6841 +4978 48 6840 6842 +4979 48 6843 6844 +4980 48 6843 6845 +4981 48 6846 6847 +4982 48 6846 6848 +4983 48 6849 6850 +4984 48 6849 6851 +4985 48 6852 6853 +4986 48 6852 6854 +4987 48 6855 6856 +4988 48 6855 6857 +4989 48 6858 6859 +4990 48 6858 6860 +4991 48 6861 6862 +4992 48 6861 6863 +4993 48 6864 6865 +4994 48 6864 6866 +4995 48 6867 6868 +4996 48 6867 6869 +4997 48 6870 6871 +4998 48 6870 6872 +4999 48 6873 6874 +5000 48 6873 6875 +5001 48 6876 6877 +5002 48 6876 6878 +5003 48 6879 6880 +5004 48 6879 6881 +5005 48 6882 6883 +5006 48 6882 6884 +5007 48 6885 6886 +5008 48 6885 6887 +5009 48 6888 6889 +5010 48 6888 6890 +5011 48 6891 6892 +5012 48 6891 6893 +5013 48 6894 6895 +5014 48 6894 6896 +5015 48 6897 6898 +5016 48 6897 6899 +5017 48 6900 6901 +5018 48 6900 6902 +5019 48 6903 6904 +5020 48 6903 6905 +5021 48 6906 6907 +5022 48 6906 6908 +5023 48 6909 6910 +5024 48 6909 6911 +5025 48 6912 6913 +5026 48 6912 6914 +5027 48 6915 6916 +5028 48 6915 6917 +5029 48 6918 6919 +5030 48 6918 6920 +5031 48 6921 6922 +5032 48 6921 6923 +5033 48 6924 6925 +5034 48 6924 6926 +5035 48 6927 6928 +5036 48 6927 6929 +5037 48 6930 6931 +5038 48 6930 6932 +5039 48 6933 6934 +5040 48 6933 6935 +5041 48 6936 6937 +5042 48 6936 6938 +5043 48 6939 6940 +5044 48 6939 6941 +5045 48 6942 6943 +5046 48 6942 6944 +5047 48 6945 6946 +5048 48 6945 6947 +5049 48 6948 6949 +5050 48 6948 6950 +5051 48 6951 6952 +5052 48 6951 6953 +5053 48 6954 6955 +5054 48 6954 6956 +5055 48 6957 6958 +5056 48 6957 6959 +5057 48 6960 6961 +5058 48 6960 6962 +5059 48 6963 6964 +5060 48 6963 6965 +5061 48 6966 6967 +5062 48 6966 6968 +5063 48 6969 6970 +5064 48 6969 6971 +5065 48 6972 6973 +5066 48 6972 6974 +5067 48 6975 6976 +5068 48 6975 6977 +5069 48 6978 6979 +5070 48 6978 6980 +5071 48 6981 6982 +5072 48 6981 6983 +5073 48 6984 6985 +5074 48 6984 6986 +5075 48 6987 6988 +5076 48 6987 6989 +5077 48 6990 6991 +5078 48 6990 6992 +5079 48 6993 6994 +5080 48 6993 6995 +5081 48 6996 6997 +5082 48 6996 6998 +5083 48 6999 7000 +5084 48 6999 7001 +5085 48 7002 7003 +5086 48 7002 7004 +5087 48 7005 7006 +5088 48 7005 7007 +5089 48 7008 7009 +5090 48 7008 7010 +5091 48 7011 7012 +5092 48 7011 7013 +5093 48 7014 7015 +5094 48 7014 7016 +5095 48 7017 7018 +5096 48 7017 7019 +5097 48 7020 7021 +5098 48 7020 7022 +5099 48 7023 7024 +5100 48 7023 7025 +5101 48 7026 7027 +5102 48 7026 7028 +5103 48 7029 7030 +5104 48 7029 7031 +5105 48 7032 7033 +5106 48 7032 7034 +5107 48 7035 7036 +5108 48 7035 7037 +5109 48 7038 7039 +5110 48 7038 7040 +5111 48 7041 7042 +5112 48 7041 7043 +5113 48 7044 7045 +5114 48 7044 7046 +5115 48 7047 7048 +5116 48 7047 7049 +5117 48 7050 7051 +5118 48 7050 7052 +5119 48 7053 7054 +5120 48 7053 7055 +5121 48 7056 7057 +5122 48 7056 7058 +5123 48 7059 7060 +5124 48 7059 7061 +5125 48 7062 7063 +5126 48 7062 7064 +5127 48 7065 7066 +5128 48 7065 7067 +5129 48 7068 7069 +5130 48 7068 7070 +5131 48 7071 7072 +5132 48 7071 7073 +5133 48 7074 7075 +5134 48 7074 7076 +5135 48 7077 7078 +5136 48 7077 7079 +5137 48 7080 7081 +5138 48 7080 7082 +5139 48 7083 7084 +5140 48 7083 7085 +5141 48 7086 7087 +5142 48 7086 7088 +5143 48 7089 7090 +5144 48 7089 7091 +5145 48 7092 7093 +5146 48 7092 7094 +5147 48 7095 7096 +5148 48 7095 7097 +5149 48 7098 7099 +5150 48 7098 7100 +5151 48 7101 7102 +5152 48 7101 7103 +5153 48 7104 7105 +5154 48 7104 7106 +5155 48 7107 7108 +5156 48 7107 7109 +5157 48 7110 7111 +5158 48 7110 7112 +5159 48 7113 7114 +5160 48 7113 7115 +5161 48 7116 7117 +5162 48 7116 7118 +5163 48 7119 7120 +5164 48 7119 7121 +5165 48 7122 7123 +5166 48 7122 7124 +5167 48 7125 7126 +5168 48 7125 7127 +5169 48 7128 7129 +5170 48 7128 7130 +5171 48 7131 7132 +5172 48 7131 7133 +5173 48 7134 7135 +5174 48 7134 7136 +5175 48 7137 7138 +5176 48 7137 7139 +5177 48 7140 7141 +5178 48 7140 7142 +5179 48 7143 7144 +5180 48 7143 7145 +5181 48 7146 7147 +5182 48 7146 7148 +5183 48 7149 7150 +5184 48 7149 7151 +5185 48 7152 7153 +5186 48 7152 7154 +5187 48 7155 7156 +5188 48 7155 7157 +5189 48 7158 7159 +5190 48 7158 7160 +5191 48 7161 7162 +5192 48 7161 7163 +5193 48 7164 7165 +5194 48 7164 7166 +5195 48 7167 7168 +5196 48 7167 7169 +5197 48 7170 7171 +5198 48 7170 7172 +5199 48 7173 7174 +5200 48 7173 7175 +5201 48 7176 7177 +5202 48 7176 7178 +5203 48 7179 7180 +5204 48 7179 7181 +5205 48 7182 7183 +5206 48 7182 7184 +5207 48 7185 7186 +5208 48 7185 7187 +5209 48 7188 7189 +5210 48 7188 7190 +5211 48 7191 7192 +5212 48 7191 7193 +5213 48 7194 7195 +5214 48 7194 7196 +5215 48 7197 7198 +5216 48 7197 7199 +5217 48 7200 7201 +5218 48 7200 7202 +5219 48 7203 7204 +5220 48 7203 7205 +5221 48 7206 7207 +5222 48 7206 7208 +5223 48 7209 7210 +5224 48 7209 7211 +5225 48 7212 7213 +5226 48 7212 7214 +5227 48 7215 7216 +5228 48 7215 7217 +5229 48 7218 7219 +5230 48 7218 7220 +5231 48 7221 7222 +5232 48 7221 7223 +5233 48 7224 7225 +5234 48 7224 7226 +5235 48 7227 7228 +5236 48 7227 7229 +5237 48 7230 7231 +5238 48 7230 7232 +5239 48 7233 7234 +5240 48 7233 7235 +5241 48 7236 7237 +5242 48 7236 7238 +5243 48 7239 7240 +5244 48 7239 7241 +5245 48 7242 7243 +5246 48 7242 7244 +5247 48 7245 7246 +5248 48 7245 7247 +5249 48 7248 7249 +5250 48 7248 7250 +5251 48 7251 7252 +5252 48 7251 7253 +5253 48 7254 7255 +5254 48 7254 7256 +5255 48 7257 7258 +5256 48 7257 7259 +5257 48 7260 7261 +5258 48 7260 7262 +5259 48 7263 7264 +5260 48 7263 7265 +5261 48 7266 7267 +5262 48 7266 7268 +5263 48 7269 7270 +5264 48 7269 7271 +5265 48 7272 7273 +5266 48 7272 7274 +5267 48 7275 7276 +5268 48 7275 7277 +5269 48 7278 7279 +5270 48 7278 7280 +5271 48 7281 7282 +5272 48 7281 7283 +5273 48 7284 7285 +5274 48 7284 7286 +5275 48 7287 7288 +5276 48 7287 7289 +5277 48 7290 7291 +5278 48 7290 7292 +5279 48 7293 7294 +5280 48 7293 7295 +5281 48 7296 7297 +5282 48 7296 7298 +5283 48 7299 7300 +5284 48 7299 7301 +5285 48 7302 7303 +5286 48 7302 7304 +5287 48 7305 7306 +5288 48 7305 7307 +5289 48 7308 7309 +5290 48 7308 7310 +5291 48 7311 7312 +5292 48 7311 7313 +5293 48 7314 7315 +5294 48 7314 7316 +5295 48 7317 7318 +5296 48 7317 7319 +5297 48 7320 7321 +5298 48 7320 7322 +5299 48 7323 7324 +5300 48 7323 7325 +5301 48 7326 7327 +5302 48 7326 7328 +5303 48 7329 7330 +5304 48 7329 7331 +5305 48 7332 7333 +5306 48 7332 7334 +5307 48 7335 7336 +5308 48 7335 7337 +5309 48 7338 7339 +5310 48 7338 7340 +5311 48 7341 7342 +5312 48 7341 7343 +5313 48 7344 7345 +5314 48 7344 7346 +5315 48 7347 7348 +5316 48 7347 7349 +5317 48 7350 7351 +5318 48 7350 7352 +5319 48 7353 7354 +5320 48 7353 7355 +5321 48 7356 7357 +5322 48 7356 7358 +5323 48 7359 7360 +5324 48 7359 7361 +5325 48 7362 7363 +5326 48 7362 7364 +5327 48 7365 7366 +5328 48 7365 7367 +5329 48 7368 7369 +5330 48 7368 7370 +5331 48 7371 7372 +5332 48 7371 7373 +5333 48 7374 7375 +5334 48 7374 7376 +5335 48 7377 7378 +5336 48 7377 7379 +5337 48 7380 7381 +5338 48 7380 7382 +5339 48 7383 7384 +5340 48 7383 7385 +5341 48 7386 7387 +5342 48 7386 7388 +5343 48 7389 7390 +5344 48 7389 7391 +5345 48 7392 7393 +5346 48 7392 7394 +5347 48 7395 7396 +5348 48 7395 7397 +5349 48 7398 7399 +5350 48 7398 7400 +5351 48 7401 7402 +5352 48 7401 7403 +5353 48 7404 7405 +5354 48 7404 7406 +5355 48 7407 7408 +5356 48 7407 7409 +5357 48 7410 7411 +5358 48 7410 7412 +5359 48 7413 7414 +5360 48 7413 7415 +5361 48 7416 7417 +5362 48 7416 7418 +5363 48 7419 7420 +5364 48 7419 7421 +5365 48 7422 7423 +5366 48 7422 7424 +5367 48 7425 7426 +5368 48 7425 7427 +5369 48 7428 7429 +5370 48 7428 7430 +5371 48 7431 7432 +5372 48 7431 7433 +5373 48 7434 7435 +5374 48 7434 7436 +5375 48 7437 7438 +5376 48 7437 7439 +5377 48 7440 7441 +5378 48 7440 7442 +5379 48 7443 7444 +5380 48 7443 7445 +5381 48 7446 7447 +5382 48 7446 7448 +5383 48 7449 7450 +5384 48 7449 7451 +5385 48 7452 7453 +5386 48 7452 7454 +5387 48 7455 7456 +5388 48 7455 7457 +5389 48 7458 7459 +5390 48 7458 7460 +5391 48 7461 7462 +5392 48 7461 7463 +5393 48 7464 7465 +5394 48 7464 7466 +5395 48 7467 7468 +5396 48 7467 7469 +5397 48 7470 7471 +5398 48 7470 7472 +5399 48 7473 7474 +5400 48 7473 7475 +5401 48 7476 7477 +5402 48 7476 7478 +5403 48 7479 7480 +5404 48 7479 7481 +5405 48 7482 7483 +5406 48 7482 7484 +5407 48 7485 7486 +5408 48 7485 7487 +5409 48 7488 7489 +5410 48 7488 7490 +5411 48 7491 7492 +5412 48 7491 7493 +5413 48 7494 7495 +5414 48 7494 7496 +5415 48 7497 7498 +5416 48 7497 7499 +5417 48 7500 7501 +5418 48 7500 7502 +5419 48 7503 7504 +5420 48 7503 7505 +5421 48 7506 7507 +5422 48 7506 7508 +5423 48 7509 7510 +5424 48 7509 7511 +5425 48 7512 7513 +5426 48 7512 7514 +5427 48 7515 7516 +5428 48 7515 7517 +5429 48 7518 7519 +5430 48 7518 7520 +5431 48 7521 7522 +5432 48 7521 7523 +5433 48 7524 7525 +5434 48 7524 7526 +5435 48 7527 7528 +5436 48 7527 7529 +5437 48 7530 7531 +5438 48 7530 7532 +5439 48 7533 7534 +5440 48 7533 7535 +5441 48 7536 7537 +5442 48 7536 7538 +5443 48 7539 7540 +5444 48 7539 7541 +5445 48 7542 7543 +5446 48 7542 7544 +5447 48 7545 7546 +5448 48 7545 7547 +5449 48 7548 7549 +5450 48 7548 7550 +5451 48 7551 7552 +5452 48 7551 7553 +5453 48 7554 7555 +5454 48 7554 7556 +5455 48 7557 7558 +5456 48 7557 7559 +5457 48 7560 7561 +5458 48 7560 7562 +5459 48 7563 7564 +5460 48 7563 7565 +5461 48 7566 7567 +5462 48 7566 7568 +5463 48 7569 7570 +5464 48 7569 7571 +5465 48 7572 7573 +5466 48 7572 7574 +5467 48 7575 7576 +5468 48 7575 7577 +5469 48 7578 7579 +5470 48 7578 7580 +5471 48 7581 7582 +5472 48 7581 7583 +5473 48 7584 7585 +5474 48 7584 7586 +5475 48 7587 7588 +5476 48 7587 7589 +5477 48 7590 7591 +5478 48 7590 7592 +5479 48 7593 7594 +5480 48 7593 7595 +5481 48 7596 7597 +5482 48 7596 7598 +5483 48 7599 7600 +5484 48 7599 7601 +5485 48 7602 7603 +5486 48 7602 7604 +5487 48 7605 7606 +5488 48 7605 7607 +5489 48 7608 7609 +5490 48 7608 7610 +5491 48 7611 7612 +5492 48 7611 7613 +5493 48 7614 7615 +5494 48 7614 7616 +5495 48 7617 7618 +5496 48 7617 7619 +5497 48 7620 7621 +5498 48 7620 7622 +5499 48 7623 7624 +5500 48 7623 7625 +5501 48 7626 7627 +5502 48 7626 7628 +5503 48 7629 7630 +5504 48 7629 7631 +5505 48 7632 7633 +5506 48 7632 7634 +5507 48 7635 7636 +5508 48 7635 7637 +5509 48 7638 7639 +5510 48 7638 7640 +5511 48 7641 7642 +5512 48 7641 7643 +5513 48 7644 7645 +5514 48 7644 7646 +5515 48 7647 7648 +5516 48 7647 7649 +5517 48 7650 7651 +5518 48 7650 7652 +5519 48 7653 7654 +5520 48 7653 7655 +5521 48 7656 7657 +5522 48 7656 7658 +5523 48 7659 7660 +5524 48 7659 7661 +5525 48 7662 7663 +5526 48 7662 7664 +5527 48 7665 7666 +5528 48 7665 7667 +5529 48 7668 7669 +5530 48 7668 7670 +5531 48 7671 7672 +5532 48 7671 7673 +5533 48 7674 7675 +5534 48 7674 7676 +5535 48 7677 7678 +5536 48 7677 7679 +5537 48 7680 7681 +5538 48 7680 7682 +5539 48 7683 7684 +5540 48 7683 7685 +5541 48 7686 7687 +5542 48 7686 7688 +5543 48 7689 7690 +5544 48 7689 7691 +5545 48 7692 7693 +5546 48 7692 7694 +5547 48 7695 7696 +5548 48 7695 7697 +5549 48 7698 7699 +5550 48 7698 7700 +5551 48 7701 7702 +5552 48 7701 7703 +5553 48 7704 7705 +5554 48 7704 7706 +5555 48 7707 7708 +5556 48 7707 7709 +5557 48 7710 7711 +5558 48 7710 7712 +5559 48 7713 7714 +5560 48 7713 7715 +5561 48 7716 7717 +5562 48 7716 7718 +5563 48 7719 7720 +5564 48 7719 7721 +5565 48 7722 7723 +5566 48 7722 7724 +5567 48 7725 7726 +5568 48 7725 7727 +5569 48 7728 7729 +5570 48 7728 7730 +5571 48 7731 7732 +5572 48 7731 7733 +5573 48 7734 7735 +5574 48 7734 7736 +5575 48 7737 7738 +5576 48 7737 7739 +5577 48 7740 7741 +5578 48 7740 7742 +5579 48 7743 7744 +5580 48 7743 7745 +5581 48 7746 7747 +5582 48 7746 7748 +5583 48 7749 7750 +5584 48 7749 7751 +5585 48 7752 7753 +5586 48 7752 7754 +5587 48 7755 7756 +5588 48 7755 7757 +5589 48 7758 7759 +5590 48 7758 7760 +5591 48 7761 7762 +5592 48 7761 7763 +5593 48 7764 7765 +5594 48 7764 7766 +5595 48 7767 7768 +5596 48 7767 7769 +5597 48 7770 7771 +5598 48 7770 7772 +5599 48 7773 7774 +5600 48 7773 7775 +5601 48 7776 7777 +5602 48 7776 7778 +5603 48 7779 7780 +5604 48 7779 7781 +5605 48 7782 7783 +5606 48 7782 7784 +5607 48 7785 7786 +5608 48 7785 7787 +5609 48 7788 7789 +5610 48 7788 7790 +5611 48 7791 7792 +5612 48 7791 7793 +5613 48 7794 7795 +5614 48 7794 7796 +5615 48 7797 7798 +5616 48 7797 7799 +5617 48 7800 7801 +5618 48 7800 7802 +5619 48 7803 7804 +5620 48 7803 7805 +5621 48 7806 7807 +5622 48 7806 7808 +5623 48 7809 7810 +5624 48 7809 7811 +5625 48 7812 7813 +5626 48 7812 7814 +5627 48 7815 7816 +5628 48 7815 7817 +5629 48 7818 7819 +5630 48 7818 7820 +5631 48 7821 7822 +5632 48 7821 7823 +5633 48 7824 7825 +5634 48 7824 7826 +5635 48 7827 7828 +5636 48 7827 7829 +5637 48 7830 7831 +5638 48 7830 7832 +5639 48 7833 7834 +5640 48 7833 7835 +5641 48 7836 7837 +5642 48 7836 7838 +5643 48 7839 7840 +5644 48 7839 7841 +5645 48 7842 7843 +5646 48 7842 7844 +5647 48 7845 7846 +5648 48 7845 7847 +5649 48 7848 7849 +5650 48 7848 7850 +5651 48 7851 7852 +5652 48 7851 7853 +5653 48 7854 7855 +5654 48 7854 7856 +5655 48 7857 7858 +5656 48 7857 7859 +5657 48 7860 7861 +5658 48 7860 7862 +5659 48 7863 7864 +5660 48 7863 7865 +5661 48 7866 7867 +5662 48 7866 7868 +5663 48 7869 7870 +5664 48 7869 7871 +5665 48 7872 7873 +5666 48 7872 7874 +5667 48 7875 7876 +5668 48 7875 7877 +5669 48 7878 7879 +5670 48 7878 7880 +5671 48 7881 7882 +5672 48 7881 7883 +5673 48 7884 7885 +5674 48 7884 7886 +5675 48 7887 7888 +5676 48 7887 7889 +5677 48 7890 7891 +5678 48 7890 7892 +5679 48 7893 7894 +5680 48 7893 7895 +5681 48 7896 7897 +5682 48 7896 7898 +5683 48 7899 7900 +5684 48 7899 7901 +5685 48 7902 7903 +5686 48 7902 7904 +5687 48 7905 7906 +5688 48 7905 7907 +5689 48 7908 7909 +5690 48 7908 7910 +5691 48 7911 7912 +5692 48 7911 7913 +5693 48 7914 7915 +5694 48 7914 7916 +5695 48 7917 7918 +5696 48 7917 7919 +5697 48 7920 7921 +5698 48 7920 7922 +5699 48 7923 7924 +5700 48 7923 7925 +5701 48 7926 7927 +5702 48 7926 7928 +5703 48 7929 7930 +5704 48 7929 7931 +5705 48 7932 7933 +5706 48 7932 7934 +5707 48 7935 7936 +5708 48 7935 7937 +5709 48 7938 7939 +5710 48 7938 7940 +5711 48 7941 7942 +5712 48 7941 7943 +5713 48 7944 7945 +5714 48 7944 7946 +5715 48 7947 7948 +5716 48 7947 7949 +5717 48 7950 7951 +5718 48 7950 7952 +5719 48 7953 7954 +5720 48 7953 7955 +5721 48 7956 7957 +5722 48 7956 7958 +5723 48 7959 7960 +5724 48 7959 7961 +5725 48 7962 7963 +5726 48 7962 7964 +5727 48 7965 7966 +5728 48 7965 7967 +5729 48 7968 7969 +5730 48 7968 7970 +5731 48 7971 7972 +5732 48 7971 7973 +5733 48 7974 7975 +5734 48 7974 7976 +5735 48 7977 7978 +5736 48 7977 7979 +5737 48 7980 7981 +5738 48 7980 7982 +5739 48 7983 7984 +5740 48 7983 7985 +5741 48 7986 7987 +5742 48 7986 7988 +5743 48 7989 7990 +5744 48 7989 7991 +5745 48 7992 7993 +5746 48 7992 7994 +5747 48 7995 7996 +5748 48 7995 7997 +5749 48 7998 7999 +5750 48 7998 8000 +5751 48 8001 8002 +5752 48 8001 8003 +5753 48 8004 8005 +5754 48 8004 8006 +5755 48 8007 8008 +5756 48 8007 8009 +5757 48 8010 8011 +5758 48 8010 8012 +5759 48 8013 8014 +5760 48 8013 8015 +5761 48 8016 8017 +5762 48 8016 8018 +5763 48 8019 8020 +5764 48 8019 8021 +5765 48 8022 8023 +5766 48 8022 8024 +5767 48 8025 8026 +5768 48 8025 8027 +5769 48 8028 8029 +5770 48 8028 8030 +5771 48 8031 8032 +5772 48 8031 8033 +5773 48 8034 8035 +5774 48 8034 8036 +5775 48 8037 8038 +5776 48 8037 8039 +5777 48 8040 8041 +5778 48 8040 8042 +5779 48 8043 8044 +5780 48 8043 8045 +5781 48 8046 8047 +5782 48 8046 8048 +5783 48 8049 8050 +5784 48 8049 8051 +5785 48 8052 8053 +5786 48 8052 8054 +5787 48 8055 8056 +5788 48 8055 8057 +5789 48 8058 8059 +5790 48 8058 8060 +5791 48 8061 8062 +5792 48 8061 8063 +5793 48 8064 8065 +5794 48 8064 8066 +5795 48 8067 8068 +5796 48 8067 8069 +5797 48 8070 8071 +5798 48 8070 8072 +5799 48 8073 8074 +5800 48 8073 8075 +5801 48 8076 8077 +5802 48 8076 8078 +5803 48 8079 8080 +5804 48 8079 8081 +5805 48 8082 8083 +5806 48 8082 8084 +5807 48 8085 8086 +5808 48 8085 8087 +5809 48 8088 8089 +5810 48 8088 8090 +5811 48 8091 8092 +5812 48 8091 8093 +5813 48 8094 8095 +5814 48 8094 8096 +5815 48 8097 8098 +5816 48 8097 8099 +5817 48 8100 8101 +5818 48 8100 8102 +5819 48 8103 8104 +5820 48 8103 8105 +5821 48 8106 8107 +5822 48 8106 8108 +5823 48 8109 8110 +5824 48 8109 8111 +5825 48 8112 8113 +5826 48 8112 8114 +5827 48 8115 8116 +5828 48 8115 8117 +5829 48 8118 8119 +5830 48 8118 8120 +5831 48 8121 8122 +5832 48 8121 8123 +5833 48 8124 8125 +5834 48 8124 8126 +5835 48 8127 8128 +5836 48 8127 8129 +5837 48 8130 8131 +5838 48 8130 8132 +5839 48 8133 8134 +5840 48 8133 8135 +5841 48 8136 8137 +5842 48 8136 8138 +5843 48 8139 8140 +5844 48 8139 8141 +5845 48 8142 8143 +5846 48 8142 8144 +5847 48 8145 8146 +5848 48 8145 8147 +5849 48 8148 8149 +5850 48 8148 8150 +5851 48 8151 8152 +5852 48 8151 8153 +5853 48 8154 8155 +5854 48 8154 8156 +5855 48 8157 8158 +5856 48 8157 8159 +5857 48 8160 8161 +5858 48 8160 8162 +5859 48 8163 8164 +5860 48 8163 8165 +5861 48 8166 8167 +5862 48 8166 8168 +5863 48 8169 8170 +5864 48 8169 8171 +5865 48 8172 8173 +5866 48 8172 8174 +5867 48 8175 8176 +5868 48 8175 8177 +5869 48 8178 8179 +5870 48 8178 8180 +5871 48 8181 8182 +5872 48 8181 8183 +5873 48 8184 8185 +5874 48 8184 8186 +5875 48 8187 8188 +5876 48 8187 8189 +5877 48 8190 8191 +5878 48 8190 8192 +5879 48 8193 8194 +5880 48 8193 8195 +5881 48 8196 8197 +5882 48 8196 8198 +5883 48 8199 8200 +5884 48 8199 8201 +5885 48 8202 8203 +5886 48 8202 8204 +5887 48 8205 8206 +5888 48 8205 8207 +5889 48 8208 8209 +5890 48 8208 8210 +5891 48 8211 8212 +5892 48 8211 8213 +5893 48 8214 8215 +5894 48 8214 8216 +5895 48 8217 8218 +5896 48 8217 8219 +5897 48 8220 8221 +5898 48 8220 8222 +5899 48 8223 8224 +5900 48 8223 8225 +5901 48 8226 8227 +5902 48 8226 8228 +5903 48 8229 8230 +5904 48 8229 8231 +5905 48 8232 8233 +5906 48 8232 8234 +5907 48 8235 8236 +5908 48 8235 8237 +5909 48 8238 8239 +5910 48 8238 8240 +5911 48 8241 8242 +5912 48 8241 8243 +5913 48 8244 8245 +5914 48 8244 8246 +5915 48 8247 8248 +5916 48 8247 8249 +5917 48 8250 8251 +5918 48 8250 8252 +5919 48 8253 8254 +5920 48 8253 8255 +5921 48 8256 8257 +5922 48 8256 8258 +5923 48 8259 8260 +5924 48 8259 8261 +5925 48 8262 8263 +5926 48 8262 8264 +5927 48 8265 8266 +5928 48 8265 8267 +5929 48 8268 8269 +5930 48 8268 8270 +5931 48 8271 8272 +5932 48 8271 8273 +5933 48 8274 8275 +5934 48 8274 8276 +5935 48 8277 8278 +5936 48 8277 8279 +5937 48 8280 8281 +5938 48 8280 8282 +5939 48 8283 8284 +5940 48 8283 8285 +5941 48 8286 8287 +5942 48 8286 8288 +5943 48 8289 8290 +5944 48 8289 8291 +5945 48 8292 8293 +5946 48 8292 8294 +5947 48 8295 8296 +5948 48 8295 8297 +5949 48 8298 8299 +5950 48 8298 8300 +5951 48 8301 8302 +5952 48 8301 8303 +5953 48 8304 8305 +5954 48 8304 8306 +5955 48 8307 8308 +5956 48 8307 8309 +5957 48 8310 8311 +5958 48 8310 8312 +5959 48 8313 8314 +5960 48 8313 8315 +5961 48 8316 8317 +5962 48 8316 8318 +5963 48 8319 8320 +5964 48 8319 8321 +5965 48 8322 8323 +5966 48 8322 8324 +5967 48 8325 8326 +5968 48 8325 8327 +5969 48 8328 8329 +5970 48 8328 8330 +5971 48 8331 8332 +5972 48 8331 8333 +5973 48 8334 8335 +5974 48 8334 8336 +5975 48 8337 8338 +5976 48 8337 8339 +5977 48 8340 8341 +5978 48 8340 8342 +5979 48 8343 8344 +5980 48 8343 8345 +5981 48 8346 8347 +5982 48 8346 8348 +5983 48 8349 8350 +5984 48 8349 8351 +5985 48 8352 8353 +5986 48 8352 8354 +5987 48 8355 8356 +5988 48 8355 8357 +5989 48 8358 8359 +5990 48 8358 8360 +5991 48 8361 8362 +5992 48 8361 8363 +5993 48 8364 8365 +5994 48 8364 8366 +5995 48 8367 8368 +5996 48 8367 8369 +5997 48 8370 8371 +5998 48 8370 8372 +5999 48 8373 8374 +6000 48 8373 8375 +6001 48 8376 8377 +6002 48 8376 8378 +6003 48 8379 8380 +6004 48 8379 8381 +6005 48 8382 8383 +6006 48 8382 8384 +6007 48 8385 8386 +6008 48 8385 8387 +6009 48 8388 8389 +6010 48 8388 8390 +6011 48 8391 8392 +6012 48 8391 8393 +6013 48 8394 8395 +6014 48 8394 8396 +6015 48 8397 8398 +6016 48 8397 8399 +6017 48 8400 8401 +6018 48 8400 8402 +6019 48 8403 8404 +6020 48 8403 8405 +6021 48 8406 8407 +6022 48 8406 8408 +6023 48 8409 8410 +6024 48 8409 8411 +6025 48 8412 8413 +6026 48 8412 8414 +6027 48 8415 8416 +6028 48 8415 8417 +6029 48 8418 8419 +6030 48 8418 8420 +6031 48 8421 8422 +6032 48 8421 8423 +6033 48 8424 8425 +6034 48 8424 8426 +6035 48 8427 8428 +6036 48 8427 8429 +6037 48 8430 8431 +6038 48 8430 8432 +6039 48 8433 8434 +6040 48 8433 8435 +6041 48 8436 8437 +6042 48 8436 8438 +6043 48 8439 8440 +6044 48 8439 8441 +6045 48 8442 8443 +6046 48 8442 8444 +6047 48 8445 8446 +6048 48 8445 8447 +6049 48 8448 8449 +6050 48 8448 8450 +6051 48 8451 8452 +6052 48 8451 8453 +6053 48 8454 8455 +6054 48 8454 8456 +6055 48 8457 8458 +6056 48 8457 8459 +6057 48 8460 8461 +6058 48 8460 8462 +6059 48 8463 8464 +6060 48 8463 8465 +6061 48 8466 8467 +6062 48 8466 8468 +6063 48 8469 8470 +6064 48 8469 8471 +6065 48 8472 8473 +6066 48 8472 8474 +6067 48 8475 8476 +6068 48 8475 8477 +6069 48 8478 8479 +6070 48 8478 8480 +6071 48 8481 8482 +6072 48 8481 8483 +6073 48 8484 8485 +6074 48 8484 8486 +6075 48 8487 8488 +6076 48 8487 8489 +6077 48 8490 8491 +6078 48 8490 8492 +6079 48 8493 8494 +6080 48 8493 8495 +6081 48 8496 8497 +6082 48 8496 8498 +6083 48 8499 8500 +6084 48 8499 8501 +6085 48 8502 8503 +6086 48 8502 8504 +6087 48 8505 8506 +6088 48 8505 8507 +6089 48 8508 8509 +6090 48 8508 8510 +6091 48 8511 8512 +6092 48 8511 8513 +6093 48 8514 8515 +6094 48 8514 8516 +6095 48 8517 8518 +6096 48 8517 8519 +6097 48 8520 8521 +6098 48 8520 8522 +6099 48 8523 8524 +6100 48 8523 8525 +6101 48 8526 8527 +6102 48 8526 8528 +6103 48 8529 8530 +6104 48 8529 8531 +6105 48 8532 8533 +6106 48 8532 8534 +6107 48 8535 8536 +6108 48 8535 8537 +6109 48 8538 8539 +6110 48 8538 8540 +6111 48 8541 8542 +6112 48 8541 8543 +6113 48 8544 8545 +6114 48 8544 8546 +6115 48 8547 8548 +6116 48 8547 8549 +6117 48 8550 8551 +6118 48 8550 8552 +6119 48 8553 8554 +6120 48 8553 8555 +6121 48 8556 8557 +6122 48 8556 8558 +6123 48 8559 8560 +6124 48 8559 8561 +6125 48 8562 8563 +6126 48 8562 8564 +6127 48 8565 8566 +6128 48 8565 8567 +6129 48 8568 8569 +6130 48 8568 8570 +6131 48 8571 8572 +6132 48 8571 8573 +6133 48 8574 8575 +6134 48 8574 8576 +6135 48 8577 8578 +6136 48 8577 8579 +6137 48 8580 8581 +6138 48 8580 8582 +6139 48 8583 8584 +6140 48 8583 8585 +6141 48 8586 8587 +6142 48 8586 8588 +6143 48 8589 8590 +6144 48 8589 8591 +6145 48 8592 8593 +6146 48 8592 8594 +6147 48 8595 8596 +6148 48 8595 8597 +6149 48 8598 8599 +6150 48 8598 8600 +6151 48 8601 8602 +6152 48 8601 8603 +6153 48 8604 8605 +6154 48 8604 8606 +6155 48 8607 8608 +6156 48 8607 8609 +6157 48 8610 8611 +6158 48 8610 8612 +6159 48 8613 8614 +6160 48 8613 8615 +6161 48 8616 8617 +6162 48 8616 8618 +6163 48 8619 8620 +6164 48 8619 8621 +6165 48 8622 8623 +6166 48 8622 8624 +6167 48 8625 8626 +6168 48 8625 8627 +6169 48 8628 8629 +6170 48 8628 8630 +6171 48 8631 8632 +6172 48 8631 8633 +6173 48 8634 8635 +6174 48 8634 8636 +6175 48 8637 8638 +6176 48 8637 8639 +6177 48 8640 8641 +6178 48 8640 8642 +6179 48 8643 8644 +6180 48 8643 8645 +6181 48 8646 8647 +6182 48 8646 8648 +6183 48 8649 8650 +6184 48 8649 8651 +6185 48 8652 8653 +6186 48 8652 8654 +6187 48 8655 8656 +6188 48 8655 8657 +6189 48 8658 8659 +6190 48 8658 8660 +6191 48 8661 8662 +6192 48 8661 8663 +6193 48 8664 8665 +6194 48 8664 8666 +6195 48 8667 8668 +6196 48 8667 8669 +6197 48 8670 8671 +6198 48 8670 8672 +6199 48 8673 8674 +6200 48 8673 8675 +6201 48 8676 8677 +6202 48 8676 8678 +6203 48 8679 8680 +6204 48 8679 8681 +6205 48 8682 8683 +6206 48 8682 8684 +6207 48 8685 8686 +6208 48 8685 8687 +6209 48 8688 8689 +6210 48 8688 8690 +6211 48 8691 8692 +6212 48 8691 8693 +6213 48 8694 8695 +6214 48 8694 8696 +6215 48 8697 8698 +6216 48 8697 8699 +6217 48 8700 8701 +6218 48 8700 8702 +6219 48 8703 8704 +6220 48 8703 8705 +6221 48 8706 8707 +6222 48 8706 8708 +6223 48 8709 8710 +6224 48 8709 8711 +6225 48 8712 8713 +6226 48 8712 8714 +6227 48 8715 8716 +6228 48 8715 8717 +6229 48 8718 8719 +6230 48 8718 8720 +6231 48 8721 8722 +6232 48 8721 8723 +6233 48 8724 8725 +6234 48 8724 8726 +6235 48 8727 8728 +6236 48 8727 8729 +6237 48 8730 8731 +6238 48 8730 8732 +6239 48 8733 8734 +6240 48 8733 8735 +6241 48 8736 8737 +6242 48 8736 8738 +6243 48 8739 8740 +6244 48 8739 8741 +6245 48 8742 8743 +6246 48 8742 8744 +6247 48 8745 8746 +6248 48 8745 8747 +6249 48 8748 8749 +6250 48 8748 8750 +6251 48 8751 8752 +6252 48 8751 8753 +6253 48 8754 8755 +6254 48 8754 8756 +6255 48 8757 8758 +6256 48 8757 8759 +6257 48 8760 8761 +6258 48 8760 8762 +6259 48 8763 8764 +6260 48 8763 8765 +6261 48 8766 8767 +6262 48 8766 8768 +6263 48 8769 8770 +6264 48 8769 8771 +6265 48 8772 8773 +6266 48 8772 8774 +6267 48 8775 8776 +6268 48 8775 8777 +6269 48 8778 8779 +6270 48 8778 8780 +6271 48 8781 8782 +6272 48 8781 8783 +6273 48 8784 8785 +6274 48 8784 8786 +6275 48 8787 8788 +6276 48 8787 8789 +6277 48 8790 8791 +6278 48 8790 8792 +6279 48 8793 8794 +6280 48 8793 8795 +6281 48 8796 8797 +6282 48 8796 8798 +6283 48 8799 8800 +6284 48 8799 8801 +6285 48 8802 8803 +6286 48 8802 8804 +6287 48 8805 8806 +6288 48 8805 8807 +6289 48 8808 8809 +6290 48 8808 8810 +6291 48 8811 8812 +6292 48 8811 8813 +6293 48 8814 8815 +6294 48 8814 8816 +6295 48 8817 8818 +6296 48 8817 8819 +6297 48 8820 8821 +6298 48 8820 8822 +6299 48 8823 8824 +6300 48 8823 8825 +6301 48 8826 8827 +6302 48 8826 8828 +6303 48 8829 8830 +6304 48 8829 8831 +6305 48 8832 8833 +6306 48 8832 8834 +6307 48 8835 8836 +6308 48 8835 8837 +6309 48 8838 8839 +6310 48 8838 8840 +6311 48 8841 8842 +6312 48 8841 8843 +6313 48 8844 8845 +6314 48 8844 8846 +6315 48 8847 8848 +6316 48 8847 8849 +6317 48 8850 8851 +6318 48 8850 8852 +6319 48 8853 8854 +6320 48 8853 8855 +6321 48 8856 8857 +6322 48 8856 8858 +6323 48 8859 8860 +6324 48 8859 8861 +6325 48 8862 8863 +6326 48 8862 8864 +6327 48 8865 8866 +6328 48 8865 8867 +6329 48 8868 8869 +6330 48 8868 8870 +6331 48 8871 8872 +6332 48 8871 8873 +6333 48 8874 8875 +6334 48 8874 8876 +6335 48 8877 8878 +6336 48 8877 8879 +6337 48 8880 8881 +6338 48 8880 8882 +6339 48 8883 8884 +6340 48 8883 8885 +6341 48 8886 8887 +6342 48 8886 8888 +6343 48 8889 8890 +6344 48 8889 8891 +6345 48 8892 8893 +6346 48 8892 8894 +6347 48 8895 8896 +6348 48 8895 8897 +6349 48 8898 8899 +6350 48 8898 8900 +6351 48 8901 8902 +6352 48 8901 8903 +6353 48 8904 8905 +6354 48 8904 8906 +6355 48 8907 8908 +6356 48 8907 8909 +6357 48 8910 8911 +6358 48 8910 8912 +6359 48 8913 8914 +6360 48 8913 8915 +6361 48 8916 8917 +6362 48 8916 8918 +6363 48 8919 8920 +6364 48 8919 8921 +6365 48 8922 8923 +6366 48 8922 8924 +6367 48 8925 8926 +6368 48 8925 8927 +6369 48 8928 8929 +6370 48 8928 8930 +6371 48 8931 8932 +6372 48 8931 8933 +6373 48 8934 8935 +6374 48 8934 8936 +6375 48 8937 8938 +6376 48 8937 8939 +6377 48 8940 8941 +6378 48 8940 8942 +6379 48 8943 8944 +6380 48 8943 8945 +6381 48 8946 8947 +6382 48 8946 8948 +6383 48 8949 8950 +6384 48 8949 8951 +6385 48 8952 8953 +6386 48 8952 8954 +6387 48 8955 8956 +6388 48 8955 8957 +6389 48 8958 8959 +6390 48 8958 8960 +6391 48 8961 8962 +6392 48 8961 8963 +6393 48 8964 8965 +6394 48 8964 8966 +6395 48 8967 8968 +6396 48 8967 8969 +6397 48 8970 8971 +6398 48 8970 8972 +6399 48 8973 8974 +6400 48 8973 8975 +6401 48 8976 8977 +6402 48 8976 8978 +6403 48 8979 8980 +6404 48 8979 8981 +6405 48 8982 8983 +6406 48 8982 8984 +6407 48 8985 8986 +6408 48 8985 8987 +6409 48 8988 8989 +6410 48 8988 8990 +6411 48 8991 8992 +6412 48 8991 8993 +6413 48 8994 8995 +6414 48 8994 8996 +6415 48 8997 8998 +6416 48 8997 8999 +6417 48 9000 9001 +6418 48 9000 9002 +6419 48 9003 9004 +6420 48 9003 9005 +6421 48 9006 9007 +6422 48 9006 9008 +6423 48 9009 9010 +6424 48 9009 9011 +6425 48 9012 9013 +6426 48 9012 9014 +6427 48 9015 9016 +6428 48 9015 9017 +6429 48 9018 9019 +6430 48 9018 9020 +6431 48 9021 9022 +6432 48 9021 9023 +6433 48 9024 9025 +6434 48 9024 9026 +6435 48 9027 9028 +6436 48 9027 9029 +6437 48 9030 9031 +6438 48 9030 9032 +6439 48 9033 9034 +6440 48 9033 9035 +6441 48 9036 9037 +6442 48 9036 9038 +6443 48 9039 9040 +6444 48 9039 9041 +6445 48 9042 9043 +6446 48 9042 9044 +6447 48 9045 9046 +6448 48 9045 9047 +6449 48 9048 9049 +6450 48 9048 9050 +6451 48 9051 9052 +6452 48 9051 9053 +6453 48 9054 9055 +6454 48 9054 9056 +6455 48 9057 9058 +6456 48 9057 9059 +6457 48 9060 9061 +6458 48 9060 9062 +6459 48 9063 9064 +6460 48 9063 9065 +6461 48 9066 9067 +6462 48 9066 9068 +6463 48 9069 9070 +6464 48 9069 9071 +6465 48 9072 9073 +6466 48 9072 9074 +6467 48 9075 9076 +6468 48 9075 9077 +6469 48 9078 9079 +6470 48 9078 9080 +6471 48 9081 9082 +6472 48 9081 9083 +6473 48 9084 9085 +6474 48 9084 9086 +6475 48 9087 9088 +6476 48 9087 9089 +6477 48 9090 9091 +6478 48 9090 9092 +6479 48 9093 9094 +6480 48 9093 9095 +6481 48 9096 9097 +6482 48 9096 9098 +6483 48 9099 9100 +6484 48 9099 9101 +6485 48 9102 9103 +6486 48 9102 9104 +6487 48 9105 9106 +6488 48 9105 9107 +6489 48 9108 9109 +6490 48 9108 9110 +6491 48 9111 9112 +6492 48 9111 9113 +6493 48 9114 9115 +6494 48 9114 9116 +6495 48 9117 9118 +6496 48 9117 9119 +6497 48 9120 9121 +6498 48 9120 9122 +6499 48 9123 9124 +6500 48 9123 9125 +6501 48 9126 9127 +6502 48 9126 9128 +6503 48 9129 9130 +6504 48 9129 9131 +6505 48 9132 9133 +6506 48 9132 9134 +6507 48 9135 9136 +6508 48 9135 9137 +6509 48 9138 9139 +6510 48 9138 9140 +6511 48 9141 9142 +6512 48 9141 9143 +6513 48 9144 9145 +6514 48 9144 9146 +6515 48 9147 9148 +6516 48 9147 9149 +6517 48 9150 9151 +6518 48 9150 9152 +6519 48 9153 9154 +6520 48 9153 9155 +6521 48 9156 9157 +6522 48 9156 9158 +6523 48 9159 9160 +6524 48 9159 9161 +6525 48 9162 9163 +6526 48 9162 9164 +6527 48 9165 9166 +6528 48 9165 9167 +6529 48 9168 9169 +6530 48 9168 9170 +6531 48 9171 9172 +6532 48 9171 9173 +6533 48 9174 9175 +6534 48 9174 9176 +6535 48 9177 9178 +6536 48 9177 9179 +6537 48 9180 9181 +6538 48 9180 9182 +6539 48 9183 9184 +6540 48 9183 9185 +6541 48 9186 9187 +6542 48 9186 9188 +6543 48 9189 9190 +6544 48 9189 9191 +6545 48 9192 9193 +6546 48 9192 9194 +6547 48 9195 9196 +6548 48 9195 9197 +6549 48 9198 9199 +6550 48 9198 9200 +6551 48 9201 9202 +6552 48 9201 9203 +6553 48 9204 9205 +6554 48 9204 9206 +6555 48 9207 9208 +6556 48 9207 9209 +6557 48 9210 9211 +6558 48 9210 9212 +6559 48 9213 9214 +6560 48 9213 9215 +6561 48 9216 9217 +6562 48 9216 9218 +6563 48 9219 9220 +6564 48 9219 9221 +6565 48 9222 9223 +6566 48 9222 9224 +6567 48 9225 9226 +6568 48 9225 9227 +6569 48 9228 9229 +6570 48 9228 9230 +6571 48 9231 9232 +6572 48 9231 9233 +6573 48 9234 9235 +6574 48 9234 9236 +6575 48 9237 9238 +6576 48 9237 9239 +6577 48 9240 9241 +6578 48 9240 9242 +6579 48 9243 9244 +6580 48 9243 9245 +6581 48 9246 9247 +6582 48 9246 9248 +6583 48 9249 9250 +6584 48 9249 9251 +6585 48 9252 9253 +6586 48 9252 9254 +6587 48 9255 9256 +6588 48 9255 9257 +6589 48 9258 9259 +6590 48 9258 9260 +6591 48 9261 9262 +6592 48 9261 9263 +6593 48 9264 9265 +6594 48 9264 9266 +6595 48 9267 9268 +6596 48 9267 9269 +6597 48 9270 9271 +6598 48 9270 9272 +6599 48 9273 9274 +6600 48 9273 9275 +6601 48 9276 9277 +6602 48 9276 9278 +6603 48 9279 9280 +6604 48 9279 9281 +6605 48 9282 9283 +6606 48 9282 9284 +6607 48 9285 9286 +6608 48 9285 9287 +6609 48 9288 9289 +6610 48 9288 9290 +6611 48 9291 9292 +6612 48 9291 9293 +6613 48 9294 9295 +6614 48 9294 9296 +6615 48 9297 9298 +6616 48 9297 9299 +6617 48 9300 9301 +6618 48 9300 9302 +6619 48 9303 9304 +6620 48 9303 9305 +6621 48 9306 9307 +6622 48 9306 9308 +6623 48 9309 9310 +6624 48 9309 9311 +6625 48 9312 9313 +6626 48 9312 9314 +6627 48 9315 9316 +6628 48 9315 9317 +6629 48 9318 9319 +6630 48 9318 9320 +6631 48 9321 9322 +6632 48 9321 9323 +6633 48 9324 9325 +6634 48 9324 9326 +6635 48 9327 9328 +6636 48 9327 9329 +6637 48 9330 9331 +6638 48 9330 9332 +6639 48 9333 9334 +6640 48 9333 9335 +6641 48 9336 9337 +6642 48 9336 9338 +6643 48 9339 9340 +6644 48 9339 9341 +6645 48 9342 9343 +6646 48 9342 9344 +6647 48 9345 9346 +6648 48 9345 9347 +6649 48 9348 9349 +6650 48 9348 9350 +6651 48 9351 9352 +6652 48 9351 9353 +6653 48 9354 9355 +6654 48 9354 9356 +6655 48 9357 9358 +6656 48 9357 9359 +6657 48 9360 9361 +6658 48 9360 9362 +6659 48 9363 9364 +6660 48 9363 9365 +6661 48 9366 9367 +6662 48 9366 9368 +6663 48 9369 9370 +6664 48 9369 9371 +6665 48 9372 9373 +6666 48 9372 9374 +6667 48 9375 9376 +6668 48 9375 9377 +6669 48 9378 9379 +6670 48 9378 9380 +6671 48 9381 9382 +6672 48 9381 9383 +6673 48 9384 9385 +6674 48 9384 9386 +6675 48 9387 9388 +6676 48 9387 9389 +6677 48 9390 9391 +6678 48 9390 9392 +6679 48 9393 9394 +6680 48 9393 9395 +6681 48 9396 9397 +6682 48 9396 9398 +6683 48 9399 9400 +6684 48 9399 9401 +6685 48 9402 9403 +6686 48 9402 9404 +6687 48 9405 9406 +6688 48 9405 9407 +6689 48 9408 9409 +6690 48 9408 9410 +6691 48 9411 9412 +6692 48 9411 9413 +6693 48 9414 9415 +6694 48 9414 9416 +6695 48 9417 9418 +6696 48 9417 9419 +6697 48 9420 9421 +6698 48 9420 9422 +6699 48 9423 9424 +6700 48 9423 9425 +6701 48 9426 9427 +6702 48 9426 9428 +6703 48 9429 9430 +6704 48 9429 9431 +6705 48 9432 9433 +6706 48 9432 9434 +6707 48 9435 9436 +6708 48 9435 9437 +6709 48 9438 9439 +6710 48 9438 9440 +6711 48 9441 9442 +6712 48 9441 9443 +6713 48 9444 9445 +6714 48 9444 9446 +6715 48 9447 9448 +6716 48 9447 9449 +6717 48 9450 9451 +6718 48 9450 9452 +6719 48 9453 9454 +6720 48 9453 9455 +6721 48 9456 9457 +6722 48 9456 9458 +6723 48 9459 9460 +6724 48 9459 9461 +6725 48 9462 9463 +6726 48 9462 9464 +6727 48 9465 9466 +6728 48 9465 9467 +6729 48 9468 9469 +6730 48 9468 9470 +6731 48 9471 9472 +6732 48 9471 9473 +6733 48 9474 9475 +6734 48 9474 9476 +6735 48 9477 9478 +6736 48 9477 9479 +6737 48 9480 9481 +6738 48 9480 9482 +6739 48 9483 9484 +6740 48 9483 9485 +6741 48 9486 9487 +6742 48 9486 9488 +6743 48 9489 9490 +6744 48 9489 9491 +6745 48 9492 9493 +6746 48 9492 9494 +6747 48 9495 9496 +6748 48 9495 9497 +6749 48 9498 9499 +6750 48 9498 9500 +6751 48 9501 9502 +6752 48 9501 9503 +6753 48 9504 9505 +6754 48 9504 9506 +6755 48 9507 9508 +6756 48 9507 9509 +6757 48 9510 9511 +6758 48 9510 9512 +6759 48 9513 9514 +6760 48 9513 9515 +6761 48 9516 9517 +6762 48 9516 9518 +6763 48 9519 9520 +6764 48 9519 9521 +6765 48 9522 9523 +6766 48 9522 9524 +6767 48 9525 9526 +6768 48 9525 9527 +6769 48 9528 9529 +6770 48 9528 9530 +6771 48 9531 9532 +6772 48 9531 9533 +6773 48 9534 9535 +6774 48 9534 9536 +6775 48 9537 9538 +6776 48 9537 9539 +6777 48 9540 9541 +6778 48 9540 9542 +6779 48 9543 9544 +6780 48 9543 9545 +6781 48 9546 9547 +6782 48 9546 9548 +6783 48 9549 9550 +6784 48 9549 9551 +6785 48 9552 9553 +6786 48 9552 9554 +6787 48 9555 9556 +6788 48 9555 9557 +6789 48 9558 9559 +6790 48 9558 9560 +6791 48 9561 9562 +6792 48 9561 9563 +6793 48 9564 9565 +6794 48 9564 9566 +6795 48 9567 9568 +6796 48 9567 9569 +6797 48 9570 9571 +6798 48 9570 9572 +6799 48 9573 9574 +6800 48 9573 9575 +6801 48 9576 9577 +6802 48 9576 9578 +6803 48 9579 9580 +6804 48 9579 9581 +6805 48 9582 9583 +6806 48 9582 9584 +6807 48 9585 9586 +6808 48 9585 9587 +6809 48 9588 9589 +6810 48 9588 9590 +6811 48 9591 9592 +6812 48 9591 9593 +6813 48 9594 9595 +6814 48 9594 9596 +6815 48 9597 9598 +6816 48 9597 9599 +6817 48 9600 9601 +6818 48 9600 9602 +6819 48 9603 9604 +6820 48 9603 9605 +6821 48 9606 9607 +6822 48 9606 9608 +6823 48 9609 9610 +6824 48 9609 9611 +6825 48 9612 9613 +6826 48 9612 9614 +6827 48 9615 9616 +6828 48 9615 9617 +6829 48 9618 9619 +6830 48 9618 9620 +6831 48 9621 9622 +6832 48 9621 9623 +6833 48 9624 9625 +6834 48 9624 9626 +6835 48 9627 9628 +6836 48 9627 9629 +6837 48 9630 9631 +6838 48 9630 9632 +6839 48 9633 9634 +6840 48 9633 9635 +6841 48 9636 9637 +6842 48 9636 9638 +6843 48 9639 9640 +6844 48 9639 9641 +6845 48 9642 9643 +6846 48 9642 9644 +6847 48 9645 9646 +6848 48 9645 9647 +6849 48 9648 9649 +6850 48 9648 9650 +6851 48 9651 9652 +6852 48 9651 9653 +6853 48 9654 9655 +6854 48 9654 9656 +6855 48 9657 9658 +6856 48 9657 9659 +6857 48 9660 9661 +6858 48 9660 9662 +6859 48 9663 9664 +6860 48 9663 9665 +6861 48 9666 9667 +6862 48 9666 9668 +6863 48 9669 9670 +6864 48 9669 9671 +6865 48 9672 9673 +6866 48 9672 9674 +6867 48 9675 9676 +6868 48 9675 9677 +6869 48 9678 9679 +6870 48 9678 9680 +6871 48 9681 9682 +6872 48 9681 9683 +6873 48 9684 9685 +6874 48 9684 9686 +6875 48 9687 9688 +6876 48 9687 9689 +6877 48 9690 9691 +6878 48 9690 9692 +6879 48 9693 9694 +6880 48 9693 9695 +6881 48 9696 9697 +6882 48 9696 9698 +6883 48 9699 9700 +6884 48 9699 9701 +6885 48 9702 9703 +6886 48 9702 9704 +6887 48 9705 9706 +6888 48 9705 9707 +6889 48 9708 9709 +6890 48 9708 9710 +6891 48 9711 9712 +6892 48 9711 9713 +6893 48 9714 9715 +6894 48 9714 9716 +6895 48 9717 9718 +6896 48 9717 9719 +6897 48 9720 9721 +6898 48 9720 9722 +6899 48 9723 9724 +6900 48 9723 9725 +6901 48 9726 9727 +6902 48 9726 9728 +6903 48 9729 9730 +6904 48 9729 9731 +6905 48 9732 9733 +6906 48 9732 9734 +6907 48 9735 9736 +6908 48 9735 9737 + +Angles + +1 1 2 1 5 +2 1 2 1 6 +3 1 2 1 7 +4 2 5 1 6 +5 2 5 1 7 +6 2 6 1 7 +7 3 1 2 3 +8 4 1 2 8 +9 5 1 2 9 +10 6 3 2 8 +11 7 3 2 9 +12 8 8 2 9 +13 9 2 3 4 +14 10 2 3 20 +15 11 4 3 20 +16 12 2 9 10 +17 13 2 9 13 +18 13 2 9 14 +19 14 10 9 13 +20 14 10 9 14 +21 15 13 9 14 +22 16 9 10 11 +23 14 9 10 15 +24 14 9 10 16 +25 17 11 10 15 +26 17 11 10 16 +27 15 15 10 16 +28 18 10 11 12 +29 19 11 12 17 +30 19 11 12 18 +31 19 11 12 19 +32 15 17 12 18 +33 15 17 12 19 +34 15 18 12 19 +35 20 3 20 21 +36 21 3 20 24 +37 22 21 20 24 +38 23 20 21 22 +39 24 20 21 25 +40 25 20 21 26 +41 6 22 21 25 +42 7 22 21 26 +43 8 25 21 26 +44 9 21 22 23 +45 10 21 22 37 +46 11 23 22 37 +47 12 21 26 27 +48 13 21 26 31 +49 13 21 26 32 +50 14 27 26 31 +51 14 27 26 32 +52 15 31 26 32 +53 26 26 27 28 +54 14 26 27 33 +55 14 26 27 34 +56 27 28 27 33 +57 27 28 27 34 +58 15 33 27 34 +59 28 27 28 29 +60 29 27 28 30 +61 11 29 28 30 +62 21 28 30 35 +63 21 28 30 36 +64 30 35 30 36 +65 20 22 37 38 +66 21 22 37 41 +67 22 38 37 41 +68 23 37 38 39 +69 24 37 38 42 +70 31 37 38 43 +71 6 39 38 42 +72 32 39 38 43 +73 33 42 38 43 +74 9 38 39 40 +75 10 38 39 56 +76 11 40 39 56 +77 34 38 43 44 +78 34 38 43 45 +79 33 38 43 47 +80 35 44 43 45 +81 8 44 43 47 +82 8 45 43 47 +83 12 43 44 46 +84 13 43 44 48 +85 13 43 44 49 +86 14 46 44 48 +87 14 46 44 49 +88 15 48 44 49 +89 13 43 45 50 +90 13 43 45 51 +91 13 43 45 52 +92 15 50 45 51 +93 15 50 45 52 +94 15 51 45 52 +95 14 44 46 53 +96 14 44 46 54 +97 14 44 46 55 +98 15 53 46 54 +99 15 53 46 55 +100 15 54 46 55 +101 20 39 56 57 +102 21 39 56 60 +103 22 57 56 60 +104 23 56 57 58 +105 24 56 57 61 +106 25 56 57 62 +107 6 58 57 61 +108 7 58 57 62 +109 8 61 57 62 +110 9 57 58 59 +111 10 57 58 76 +112 11 59 58 76 +113 36 57 62 63 +114 13 57 62 69 +115 13 57 62 70 +116 37 63 62 69 +117 37 63 62 70 +118 15 69 62 70 +119 38 62 63 64 +120 38 62 63 65 +121 39 64 63 65 +122 39 63 64 66 +123 40 63 64 71 +124 40 66 64 71 +125 39 63 65 67 +126 40 63 65 72 +127 40 67 65 72 +128 39 64 66 68 +129 40 64 66 73 +130 40 68 66 73 +131 39 65 67 68 +132 40 65 67 74 +133 40 68 67 74 +134 39 66 68 67 +135 40 66 68 75 +136 40 67 68 75 +137 20 58 76 77 +138 21 58 76 80 +139 22 77 76 80 +140 23 76 77 78 +141 24 76 77 81 +142 31 76 77 82 +143 6 78 77 81 +144 32 78 77 82 +145 33 81 77 82 +146 9 77 78 79 +147 10 77 78 92 +148 11 79 78 92 +149 34 77 82 83 +150 34 77 82 84 +151 33 77 82 85 +152 35 83 82 84 +153 8 83 82 85 +154 8 84 82 85 +155 13 82 83 86 +156 13 82 83 87 +157 13 82 83 88 +158 15 86 83 87 +159 15 86 83 88 +160 15 87 83 88 +161 13 82 84 89 +162 13 82 84 90 +163 13 82 84 91 +164 15 89 84 90 +165 15 89 84 91 +166 15 90 84 91 +167 20 78 92 93 +168 21 78 92 96 +169 22 93 92 96 +170 23 92 93 94 +171 24 92 93 97 +172 25 92 93 98 +173 6 94 93 97 +174 7 94 93 98 +175 8 97 93 98 +176 9 93 94 95 +177 10 93 94 114 +178 11 95 94 114 +179 12 93 98 99 +180 13 93 98 103 +181 13 93 98 104 +182 14 99 98 103 +183 14 99 98 104 +184 15 103 98 104 +185 41 98 99 100 +186 14 98 99 105 +187 14 98 99 106 +188 14 100 99 105 +189 14 100 99 106 +190 15 105 99 106 +191 41 99 100 101 +192 14 99 100 107 +193 14 99 100 108 +194 14 101 100 107 +195 14 101 100 108 +196 15 107 100 108 +197 42 100 101 102 +198 14 100 101 109 +199 14 100 101 110 +200 43 102 101 109 +201 43 102 101 110 +202 15 109 101 110 +203 44 101 102 111 +204 44 101 102 112 +205 44 101 102 113 +206 45 111 102 112 +207 45 111 102 113 +208 45 112 102 113 +209 20 94 114 115 +210 21 94 114 118 +211 22 115 114 118 +212 23 114 115 116 +213 24 114 115 119 +214 31 114 115 120 +215 6 116 115 119 +216 32 116 115 120 +217 33 119 115 120 +218 9 115 116 117 +219 10 115 116 128 +220 11 117 116 128 +221 46 115 120 121 +222 34 115 120 122 +223 33 115 120 123 +224 47 121 120 122 +225 48 121 120 123 +226 8 122 120 123 +227 49 120 121 124 +228 13 120 122 125 +229 13 120 122 126 +230 13 120 122 127 +231 15 125 122 126 +232 15 125 122 127 +233 15 126 122 127 +234 20 116 128 129 +235 21 116 128 132 +236 22 129 128 132 +237 23 128 129 130 +238 24 128 129 133 +239 25 128 129 134 +240 6 130 129 133 +241 7 130 129 134 +242 8 133 129 134 +243 9 129 130 131 +244 10 129 130 147 +245 11 131 130 147 +246 50 129 134 135 +247 13 129 134 138 +248 13 129 134 139 +249 13 135 134 138 +250 13 135 134 139 +251 15 138 134 139 +252 35 134 135 136 +253 35 134 135 137 +254 8 134 135 140 +255 35 136 135 137 +256 8 136 135 140 +257 8 137 135 140 +258 13 135 136 141 +259 13 135 136 142 +260 13 135 136 143 +261 15 141 136 142 +262 15 141 136 143 +263 15 142 136 143 +264 13 135 137 144 +265 13 135 137 145 +266 13 135 137 146 +267 15 144 137 145 +268 15 144 137 146 +269 15 145 137 146 +270 20 130 147 148 +271 21 130 147 151 +272 22 148 147 151 +273 23 147 148 149 +274 24 147 148 152 +275 31 147 148 153 +276 6 149 148 152 +277 32 149 148 153 +278 33 152 148 153 +279 9 148 149 150 +280 10 148 149 161 +281 11 150 149 161 +282 46 148 153 154 +283 34 148 153 155 +284 33 148 153 156 +285 47 154 153 155 +286 48 154 153 156 +287 8 155 153 156 +288 49 153 154 157 +289 13 153 155 158 +290 13 153 155 159 +291 13 153 155 160 +292 15 158 155 159 +293 15 158 155 160 +294 15 159 155 160 +295 51 149 161 162 +296 21 149 161 165 +297 52 162 161 165 +298 53 161 162 163 +299 54 161 162 166 +300 54 161 162 167 +301 55 163 162 166 +302 55 163 162 167 +303 56 166 162 167 +304 57 162 163 164 +305 58 162 163 168 +306 11 164 163 168 +307 20 163 168 169 +308 21 163 168 172 +309 22 169 168 172 +310 23 168 169 170 +311 24 168 169 173 +312 25 168 169 174 +313 6 170 169 173 +314 7 170 169 174 +315 8 173 169 174 +316 9 169 170 171 +317 10 169 170 190 +318 11 171 170 190 +319 12 169 174 175 +320 13 169 174 179 +321 13 169 174 180 +322 14 175 174 179 +323 14 175 174 180 +324 15 179 174 180 +325 41 174 175 176 +326 14 174 175 181 +327 14 174 175 182 +328 14 176 175 181 +329 14 176 175 182 +330 15 181 175 182 +331 41 175 176 177 +332 14 175 176 183 +333 14 175 176 184 +334 14 177 176 183 +335 14 177 176 184 +336 15 183 176 184 +337 42 176 177 178 +338 14 176 177 185 +339 14 176 177 186 +340 43 178 177 185 +341 43 178 177 186 +342 15 185 177 186 +343 44 177 178 187 +344 44 177 178 188 +345 44 177 178 189 +346 45 187 178 188 +347 45 187 178 189 +348 45 188 178 189 +349 20 170 190 191 +350 21 170 190 194 +351 22 191 190 194 +352 23 190 191 192 +353 24 190 191 195 +354 31 190 191 196 +355 6 192 191 195 +356 32 192 191 196 +357 33 195 191 196 +358 9 191 192 193 +359 10 191 192 204 +360 11 193 192 204 +361 46 191 196 197 +362 34 191 196 198 +363 33 191 196 199 +364 47 197 196 198 +365 48 197 196 199 +366 8 198 196 199 +367 49 196 197 200 +368 13 196 198 201 +369 13 196 198 202 +370 13 196 198 203 +371 15 201 198 202 +372 15 201 198 203 +373 15 202 198 203 +374 20 192 204 205 +375 21 192 204 208 +376 22 205 204 208 +377 23 204 205 206 +378 24 204 205 209 +379 31 204 205 210 +380 6 206 205 209 +381 32 206 205 210 +382 33 209 205 210 +383 9 205 206 207 +384 10 205 206 223 +385 11 207 206 223 +386 34 205 210 211 +387 34 205 210 212 +388 33 205 210 214 +389 35 211 210 212 +390 8 211 210 214 +391 8 212 210 214 +392 12 210 211 213 +393 13 210 211 215 +394 13 210 211 216 +395 14 213 211 215 +396 14 213 211 216 +397 15 215 211 216 +398 13 210 212 217 +399 13 210 212 218 +400 13 210 212 219 +401 15 217 212 218 +402 15 217 212 219 +403 15 218 212 219 +404 14 211 213 220 +405 14 211 213 221 +406 14 211 213 222 +407 15 220 213 221 +408 15 220 213 222 +409 15 221 213 222 +410 20 206 223 224 +411 21 206 223 227 +412 22 224 223 227 +413 23 223 224 225 +414 24 223 224 228 +415 31 223 224 229 +416 6 225 224 228 +417 32 225 224 229 +418 33 228 224 229 +419 9 224 225 226 +420 10 224 225 237 +421 11 226 225 237 +422 46 224 229 230 +423 34 224 229 231 +424 33 224 229 232 +425 47 230 229 231 +426 48 230 229 232 +427 8 231 229 232 +428 49 229 230 233 +429 13 229 231 234 +430 13 229 231 235 +431 13 229 231 236 +432 15 234 231 235 +433 15 234 231 236 +434 15 235 231 236 +435 20 225 237 238 +436 21 225 237 241 +437 22 238 237 241 +438 23 237 238 239 +439 24 237 238 242 +440 25 237 238 243 +441 6 239 238 242 +442 7 239 238 243 +443 8 242 238 243 +444 9 238 239 240 +445 10 238 239 256 +446 11 240 239 256 +447 50 238 243 244 +448 13 238 243 247 +449 13 238 243 248 +450 13 244 243 247 +451 13 244 243 248 +452 15 247 243 248 +453 35 243 244 245 +454 35 243 244 246 +455 8 243 244 249 +456 35 245 244 246 +457 8 245 244 249 +458 8 246 244 249 +459 13 244 245 250 +460 13 244 245 251 +461 13 244 245 252 +462 15 250 245 251 +463 15 250 245 252 +464 15 251 245 252 +465 13 244 246 253 +466 13 244 246 254 +467 13 244 246 255 +468 15 253 246 254 +469 15 253 246 255 +470 15 254 246 255 +471 20 239 256 257 +472 21 239 256 260 +473 22 257 256 260 +474 23 256 257 258 +475 24 256 257 261 +476 25 256 257 262 +477 6 258 257 261 +478 7 258 257 262 +479 8 261 257 262 +480 9 257 258 259 +481 10 257 258 271 +482 11 259 258 271 +483 12 257 262 263 +484 13 257 262 267 +485 13 257 262 268 +486 14 263 262 267 +487 14 263 262 268 +488 15 267 262 268 +489 59 262 263 264 +490 14 262 263 269 +491 14 262 263 270 +492 60 264 263 269 +493 60 264 263 270 +494 15 269 263 270 +495 61 263 264 265 +496 61 263 264 266 +497 62 265 264 266 +498 20 258 271 272 +499 21 258 271 275 +500 22 272 271 275 +501 23 271 272 273 +502 24 271 272 276 +503 31 271 272 277 +504 6 273 272 276 +505 32 273 272 277 +506 33 276 272 277 +507 9 272 273 274 +508 10 272 273 287 +509 11 274 273 287 +510 34 272 277 278 +511 34 272 277 279 +512 33 272 277 280 +513 35 278 277 279 +514 8 278 277 280 +515 8 279 277 280 +516 13 277 278 281 +517 13 277 278 282 +518 13 277 278 283 +519 15 281 278 282 +520 15 281 278 283 +521 15 282 278 283 +522 13 277 279 284 +523 13 277 279 285 +524 13 277 279 286 +525 15 284 279 285 +526 15 284 279 286 +527 15 285 279 286 +528 20 273 287 288 +529 21 273 287 291 +530 22 288 287 291 +531 23 287 288 289 +532 24 287 288 292 +533 25 287 288 293 +534 6 289 288 292 +535 7 289 288 293 +536 8 292 288 293 +537 9 288 289 290 +538 63 288 289 302 +539 64 290 289 302 +540 12 288 293 294 +541 13 288 293 298 +542 13 288 293 299 +543 14 294 293 298 +544 14 294 293 299 +545 15 298 293 299 +546 59 293 294 295 +547 14 293 294 300 +548 14 293 294 301 +549 60 295 294 300 +550 60 295 294 301 +551 15 300 294 301 +552 61 294 295 296 +553 61 294 295 297 +554 62 296 295 297 +555 65 289 302 303 +556 66 289 302 309 +557 67 303 302 309 +558 68 302 303 304 +559 69 302 303 306 +560 70 302 303 307 +561 6 304 303 306 +562 71 304 303 307 +563 72 306 303 307 +564 9 303 304 305 +565 10 303 304 316 +566 11 305 304 316 +567 73 303 307 308 +568 74 303 307 310 +569 74 303 307 311 +570 75 308 307 310 +571 75 308 307 311 +572 76 310 307 311 +573 77 307 308 309 +574 75 307 308 312 +575 75 307 308 313 +576 75 309 308 312 +577 75 309 308 313 +578 76 312 308 313 +579 78 302 309 308 +580 79 302 309 314 +581 79 302 309 315 +582 80 308 309 314 +583 80 308 309 315 +584 81 314 309 315 +585 20 304 316 317 +586 21 304 316 320 +587 22 317 316 320 +588 23 316 317 318 +589 24 316 317 321 +590 25 316 317 322 +591 6 318 317 321 +592 7 318 317 322 +593 8 321 317 322 +594 9 317 318 319 +595 10 317 318 327 +596 11 319 318 327 +597 82 317 322 323 +598 13 317 322 324 +599 13 317 322 325 +600 83 323 322 324 +601 83 323 322 325 +602 15 324 322 325 +603 84 322 323 326 +604 20 318 327 328 +605 21 318 327 331 +606 22 328 327 331 +607 23 327 328 329 +608 24 327 328 332 +609 25 327 328 333 +610 6 329 328 332 +611 7 329 328 333 +612 8 332 328 333 +613 9 328 329 330 +614 10 328 329 339 +615 11 330 329 339 +616 85 328 333 334 +617 13 328 333 337 +618 13 328 333 338 +619 60 334 333 337 +620 60 334 333 338 +621 15 337 333 338 +622 61 333 334 335 +623 61 333 334 336 +624 62 335 334 336 +625 20 329 339 340 +626 21 329 339 343 +627 22 340 339 343 +628 23 339 340 341 +629 24 339 340 344 +630 31 339 340 345 +631 6 341 340 344 +632 32 341 340 345 +633 33 344 340 345 +634 9 340 341 342 +635 10 340 341 353 +636 11 342 341 353 +637 46 340 345 346 +638 34 340 345 347 +639 33 340 345 348 +640 47 346 345 347 +641 48 346 345 348 +642 8 347 345 348 +643 49 345 346 349 +644 13 345 347 350 +645 13 345 347 351 +646 13 345 347 352 +647 15 350 347 351 +648 15 350 347 352 +649 15 351 347 352 +650 20 341 353 354 +651 21 341 353 357 +652 22 354 353 357 +653 23 353 354 355 +654 24 353 354 358 +655 31 353 354 359 +656 6 355 354 358 +657 32 355 354 359 +658 33 358 354 359 +659 9 354 355 356 +660 10 354 355 372 +661 11 356 355 372 +662 34 354 359 360 +663 34 354 359 361 +664 33 354 359 363 +665 35 360 359 361 +666 8 360 359 363 +667 8 361 359 363 +668 12 359 360 362 +669 13 359 360 364 +670 13 359 360 365 +671 14 362 360 364 +672 14 362 360 365 +673 15 364 360 365 +674 13 359 361 366 +675 13 359 361 367 +676 13 359 361 368 +677 15 366 361 367 +678 15 366 361 368 +679 15 367 361 368 +680 14 360 362 369 +681 14 360 362 370 +682 14 360 362 371 +683 15 369 362 370 +684 15 369 362 371 +685 15 370 362 371 +686 20 355 372 373 +687 21 355 372 376 +688 22 373 372 376 +689 23 372 373 374 +690 24 372 373 377 +691 25 372 373 378 +692 6 374 373 377 +693 7 374 373 378 +694 8 377 373 378 +695 9 373 374 375 +696 10 373 374 387 +697 11 375 374 387 +698 12 373 378 379 +699 13 373 378 383 +700 13 373 378 384 +701 14 379 378 383 +702 14 379 378 384 +703 15 383 378 384 +704 59 378 379 380 +705 14 378 379 385 +706 14 378 379 386 +707 60 380 379 385 +708 60 380 379 386 +709 15 385 379 386 +710 61 379 380 381 +711 61 379 380 382 +712 62 381 380 382 +713 20 374 387 388 +714 21 374 387 391 +715 22 388 387 391 +716 23 387 388 389 +717 24 387 388 392 +718 25 387 388 393 +719 6 389 388 392 +720 7 389 388 393 +721 8 392 388 393 +722 9 388 389 390 +723 10 388 389 401 +724 11 390 389 401 +725 86 388 393 394 +726 13 388 393 397 +727 13 388 393 398 +728 27 394 393 397 +729 27 394 393 398 +730 15 397 393 398 +731 28 393 394 395 +732 29 393 394 396 +733 11 395 394 396 +734 21 394 396 399 +735 21 394 396 400 +736 30 399 396 400 +737 20 389 401 402 +738 21 389 401 405 +739 22 402 401 405 +740 23 401 402 403 +741 24 401 402 406 +742 31 401 402 407 +743 6 403 402 406 +744 32 403 402 407 +745 33 406 402 407 +746 9 402 403 404 +747 10 402 403 417 +748 11 404 403 417 +749 34 402 407 408 +750 34 402 407 409 +751 33 402 407 410 +752 35 408 407 409 +753 8 408 407 410 +754 8 409 407 410 +755 13 407 408 411 +756 13 407 408 412 +757 13 407 408 413 +758 15 411 408 412 +759 15 411 408 413 +760 15 412 408 413 +761 13 407 409 414 +762 13 407 409 415 +763 13 407 409 416 +764 15 414 409 415 +765 15 414 409 416 +766 15 415 409 416 +767 20 403 417 418 +768 21 403 417 421 +769 22 418 417 421 +770 23 417 418 419 +771 24 417 418 422 +772 25 417 418 423 +773 6 419 418 422 +774 7 419 418 423 +775 8 422 418 423 +776 9 418 419 420 +777 10 418 419 439 +778 11 420 419 439 +779 12 418 423 424 +780 13 418 423 428 +781 13 418 423 429 +782 14 424 423 428 +783 14 424 423 429 +784 15 428 423 429 +785 41 423 424 425 +786 14 423 424 430 +787 14 423 424 431 +788 14 425 424 430 +789 14 425 424 431 +790 15 430 424 431 +791 41 424 425 426 +792 14 424 425 432 +793 14 424 425 433 +794 14 426 425 432 +795 14 426 425 433 +796 15 432 425 433 +797 42 425 426 427 +798 14 425 426 434 +799 14 425 426 435 +800 43 427 426 434 +801 43 427 426 435 +802 15 434 426 435 +803 44 426 427 436 +804 44 426 427 437 +805 44 426 427 438 +806 45 436 427 437 +807 45 436 427 438 +808 45 437 427 438 +809 20 419 439 440 +810 21 419 439 443 +811 22 440 439 443 +812 23 439 440 441 +813 24 439 440 444 +814 25 439 440 445 +815 6 441 440 444 +816 7 441 440 445 +817 8 444 440 445 +818 9 440 441 442 +819 10 440 441 449 +820 11 442 441 449 +821 13 440 445 446 +822 13 440 445 447 +823 13 440 445 448 +824 15 446 445 447 +825 15 446 445 448 +826 15 447 445 448 +827 20 441 449 450 +828 21 441 449 453 +829 22 450 449 453 +830 23 449 450 451 +831 24 449 450 454 +832 25 449 450 455 +833 6 451 450 454 +834 7 451 450 455 +835 8 454 450 455 +836 9 450 451 452 +837 10 450 451 471 +838 11 452 451 471 +839 12 450 455 456 +840 13 450 455 460 +841 13 450 455 461 +842 14 456 455 460 +843 14 456 455 461 +844 15 460 455 461 +845 41 455 456 457 +846 14 455 456 462 +847 14 455 456 463 +848 14 457 456 462 +849 14 457 456 463 +850 15 462 456 463 +851 41 456 457 458 +852 14 456 457 464 +853 14 456 457 465 +854 14 458 457 464 +855 14 458 457 465 +856 15 464 457 465 +857 42 457 458 459 +858 14 457 458 466 +859 14 457 458 467 +860 43 459 458 466 +861 43 459 458 467 +862 15 466 458 467 +863 44 458 459 468 +864 44 458 459 469 +865 44 458 459 470 +866 45 468 459 469 +867 45 468 459 470 +868 45 469 459 470 +869 20 451 471 472 +870 21 451 471 475 +871 22 472 471 475 +872 23 471 472 473 +873 24 471 472 476 +874 31 471 472 477 +875 6 473 472 476 +876 32 473 472 477 +877 33 476 472 477 +878 9 472 473 474 +879 10 472 473 490 +880 11 474 473 490 +881 34 472 477 478 +882 34 472 477 479 +883 33 472 477 481 +884 35 478 477 479 +885 8 478 477 481 +886 8 479 477 481 +887 12 477 478 480 +888 13 477 478 482 +889 13 477 478 483 +890 14 480 478 482 +891 14 480 478 483 +892 15 482 478 483 +893 13 477 479 484 +894 13 477 479 485 +895 13 477 479 486 +896 15 484 479 485 +897 15 484 479 486 +898 15 485 479 486 +899 14 478 480 487 +900 14 478 480 488 +901 14 478 480 489 +902 15 487 480 488 +903 15 487 480 489 +904 15 488 480 489 +905 20 473 490 491 +906 21 473 490 494 +907 22 491 490 494 +908 23 490 491 492 +909 24 490 491 495 +910 25 490 491 496 +911 6 492 491 495 +912 7 492 491 496 +913 8 495 491 496 +914 9 491 492 493 +915 10 491 492 507 +916 11 493 492 507 +917 12 491 496 497 +918 13 491 496 501 +919 13 491 496 502 +920 14 497 496 501 +921 14 497 496 502 +922 15 501 496 502 +923 26 496 497 498 +924 14 496 497 503 +925 14 496 497 504 +926 27 498 497 503 +927 27 498 497 504 +928 15 503 497 504 +929 28 497 498 499 +930 29 497 498 500 +931 11 499 498 500 +932 21 498 500 505 +933 21 498 500 506 +934 30 505 500 506 +935 20 492 507 508 +936 21 492 507 511 +937 22 508 507 511 +938 23 507 508 509 +939 24 507 508 512 +940 25 507 508 513 +941 6 509 508 512 +942 7 509 508 513 +943 8 512 508 513 +944 9 508 509 510 +945 10 508 509 519 +946 11 510 509 519 +947 85 508 513 514 +948 13 508 513 517 +949 13 508 513 518 +950 60 514 513 517 +951 60 514 513 518 +952 15 517 513 518 +953 61 513 514 515 +954 61 513 514 516 +955 62 515 514 516 +956 20 509 519 520 +957 21 509 519 523 +958 22 520 519 523 +959 23 519 520 521 +960 24 519 520 524 +961 25 519 520 525 +962 6 521 520 524 +963 7 521 520 525 +964 8 524 520 525 +965 9 520 521 522 +966 10 520 521 541 +967 11 522 521 541 +968 12 520 525 526 +969 13 520 525 530 +970 13 520 525 531 +971 14 526 525 530 +972 14 526 525 531 +973 15 530 525 531 +974 41 525 526 527 +975 14 525 526 532 +976 14 525 526 533 +977 14 527 526 532 +978 14 527 526 533 +979 15 532 526 533 +980 41 526 527 528 +981 14 526 527 534 +982 14 526 527 535 +983 14 528 527 534 +984 14 528 527 535 +985 15 534 527 535 +986 42 527 528 529 +987 14 527 528 536 +988 14 527 528 537 +989 43 529 528 536 +990 43 529 528 537 +991 15 536 528 537 +992 44 528 529 538 +993 44 528 529 539 +994 44 528 529 540 +995 45 538 529 539 +996 45 538 529 540 +997 45 539 529 540 +998 20 521 541 542 +999 21 521 541 545 +1000 22 542 541 545 +1001 23 541 542 543 +1002 24 541 542 546 +1003 25 541 542 547 +1004 6 543 542 546 +1005 7 543 542 547 +1006 8 546 542 547 +1007 9 542 543 544 +1008 10 542 543 556 +1009 11 544 543 556 +1010 12 542 547 548 +1011 13 542 547 552 +1012 13 542 547 553 +1013 14 548 547 552 +1014 14 548 547 553 +1015 15 552 547 553 +1016 59 547 548 549 +1017 14 547 548 554 +1018 14 547 548 555 +1019 60 549 548 554 +1020 60 549 548 555 +1021 15 554 548 555 +1022 61 548 549 550 +1023 61 548 549 551 +1024 62 550 549 551 +1025 51 543 556 557 +1026 21 543 556 560 +1027 52 557 556 560 +1028 53 556 557 558 +1029 54 556 557 561 +1030 54 556 557 562 +1031 55 558 557 561 +1032 55 558 557 562 +1033 56 561 557 562 +1034 57 557 558 559 +1035 58 557 558 563 +1036 11 559 558 563 +1037 20 558 563 564 +1038 21 558 563 567 +1039 22 564 563 567 +1040 23 563 564 565 +1041 24 563 564 568 +1042 31 563 564 569 +1043 6 565 564 568 +1044 32 565 564 569 +1045 33 568 564 569 +1046 9 564 565 566 +1047 63 564 565 582 +1048 64 566 565 582 +1049 34 564 569 570 +1050 34 564 569 571 +1051 33 564 569 573 +1052 35 570 569 571 +1053 8 570 569 573 +1054 8 571 569 573 +1055 12 569 570 572 +1056 13 569 570 574 +1057 13 569 570 575 +1058 14 572 570 574 +1059 14 572 570 575 +1060 15 574 570 575 +1061 13 569 571 576 +1062 13 569 571 577 +1063 13 569 571 578 +1064 15 576 571 577 +1065 15 576 571 578 +1066 15 577 571 578 +1067 14 570 572 579 +1068 14 570 572 580 +1069 14 570 572 581 +1070 15 579 572 580 +1071 15 579 572 581 +1072 15 580 572 581 +1073 65 565 582 583 +1074 66 565 582 589 +1075 67 583 582 589 +1076 68 582 583 584 +1077 69 582 583 586 +1078 70 582 583 587 +1079 6 584 583 586 +1080 71 584 583 587 +1081 72 586 583 587 +1082 9 583 584 585 +1083 63 583 584 596 +1084 64 585 584 596 +1085 73 583 587 588 +1086 74 583 587 590 +1087 74 583 587 591 +1088 75 588 587 590 +1089 75 588 587 591 +1090 76 590 587 591 +1091 77 587 588 589 +1092 75 587 588 592 +1093 75 587 588 593 +1094 75 589 588 592 +1095 75 589 588 593 +1096 76 592 588 593 +1097 78 582 589 588 +1098 79 582 589 594 +1099 79 582 589 595 +1100 80 588 589 594 +1101 80 588 589 595 +1102 81 594 589 595 +1103 65 584 596 597 +1104 66 584 596 603 +1105 67 597 596 603 +1106 68 596 597 598 +1107 69 596 597 600 +1108 70 596 597 601 +1109 6 598 597 600 +1110 71 598 597 601 +1111 72 600 597 601 +1112 9 597 598 599 +1113 10 597 598 610 +1114 11 599 598 610 +1115 73 597 601 602 +1116 74 597 601 604 +1117 74 597 601 605 +1118 75 602 601 604 +1119 75 602 601 605 +1120 76 604 601 605 +1121 77 601 602 603 +1122 75 601 602 606 +1123 75 601 602 607 +1124 75 603 602 606 +1125 75 603 602 607 +1126 76 606 602 607 +1127 78 596 603 602 +1128 79 596 603 608 +1129 79 596 603 609 +1130 80 602 603 608 +1131 80 602 603 609 +1132 81 608 603 609 +1133 20 598 610 611 +1134 21 598 610 614 +1135 22 611 610 614 +1136 23 610 611 612 +1137 24 610 611 615 +1138 25 610 611 616 +1139 6 612 611 615 +1140 7 612 611 616 +1141 8 615 611 616 +1142 9 611 612 613 +1143 10 611 612 622 +1144 11 613 612 622 +1145 85 611 616 617 +1146 13 611 616 620 +1147 13 611 616 621 +1148 60 617 616 620 +1149 60 617 616 621 +1150 15 620 616 621 +1151 61 616 617 618 +1152 61 616 617 619 +1153 62 618 617 619 +1154 20 612 622 623 +1155 21 612 622 626 +1156 22 623 622 626 +1157 23 622 623 624 +1158 24 622 623 627 +1159 25 622 623 628 +1160 6 624 623 627 +1161 7 624 623 628 +1162 8 627 623 628 +1163 9 623 624 625 +1164 10 623 624 639 +1165 11 625 624 639 +1166 12 623 628 629 +1167 13 623 628 633 +1168 13 623 628 634 +1169 14 629 628 633 +1170 14 629 628 634 +1171 15 633 628 634 +1172 26 628 629 630 +1173 14 628 629 635 +1174 14 628 629 636 +1175 27 630 629 635 +1176 27 630 629 636 +1177 15 635 629 636 +1178 28 629 630 631 +1179 29 629 630 632 +1180 11 631 630 632 +1181 21 630 632 637 +1182 21 630 632 638 +1183 30 637 632 638 +1184 20 624 639 640 +1185 21 624 639 643 +1186 22 640 639 643 +1187 23 639 640 641 +1188 24 639 640 644 +1189 25 639 640 645 +1190 6 641 640 644 +1191 7 641 640 645 +1192 8 644 640 645 +1193 9 640 641 642 +1194 10 640 641 656 +1195 11 642 641 656 +1196 12 640 645 646 +1197 13 640 645 650 +1198 13 640 645 651 +1199 14 646 645 650 +1200 14 646 645 651 +1201 15 650 645 651 +1202 26 645 646 647 +1203 14 645 646 652 +1204 14 645 646 653 +1205 27 647 646 652 +1206 27 647 646 653 +1207 15 652 646 653 +1208 28 646 647 648 +1209 29 646 647 649 +1210 11 648 647 649 +1211 21 647 649 654 +1212 21 647 649 655 +1213 30 654 649 655 +1214 20 641 656 657 +1215 21 641 656 660 +1216 22 657 656 660 +1217 23 656 657 658 +1218 24 656 657 661 +1219 25 656 657 662 +1220 6 658 657 661 +1221 7 658 657 662 +1222 8 661 657 662 +1223 9 657 658 659 +1224 10 657 658 680 +1225 11 659 658 680 +1226 12 657 662 663 +1227 13 657 662 669 +1228 13 657 662 670 +1229 14 663 662 669 +1230 14 663 662 670 +1231 15 669 662 670 +1232 41 662 663 664 +1233 14 662 663 671 +1234 14 662 663 672 +1235 14 664 663 671 +1236 14 664 663 672 +1237 15 671 663 672 +1238 87 663 664 665 +1239 14 663 664 673 +1240 14 663 664 674 +1241 88 665 664 673 +1242 88 665 664 674 +1243 15 673 664 674 +1244 89 664 665 666 +1245 90 664 665 675 +1246 91 666 665 675 +1247 92 665 666 667 +1248 92 665 666 668 +1249 92 667 666 668 +1250 91 666 667 676 +1251 91 666 667 677 +1252 93 676 667 677 +1253 91 666 668 678 +1254 91 666 668 679 +1255 93 678 668 679 +1256 20 658 680 681 +1257 21 658 680 684 +1258 22 681 680 684 +1259 23 680 681 682 +1260 24 680 681 685 +1261 25 680 681 686 +1262 6 682 681 685 +1263 7 682 681 686 +1264 8 685 681 686 +1265 9 681 682 683 +1266 10 681 682 699 +1267 11 683 682 699 +1268 50 681 686 687 +1269 13 681 686 690 +1270 13 681 686 691 +1271 13 687 686 690 +1272 13 687 686 691 +1273 15 690 686 691 +1274 35 686 687 688 +1275 35 686 687 689 +1276 8 686 687 692 +1277 35 688 687 689 +1278 8 688 687 692 +1279 8 689 687 692 +1280 13 687 688 693 +1281 13 687 688 694 +1282 13 687 688 695 +1283 15 693 688 694 +1284 15 693 688 695 +1285 15 694 688 695 +1286 13 687 689 696 +1287 13 687 689 697 +1288 13 687 689 698 +1289 15 696 689 697 +1290 15 696 689 698 +1291 15 697 689 698 +1292 20 682 699 700 +1293 21 682 699 703 +1294 22 700 699 703 +1295 23 699 700 701 +1296 24 699 700 704 +1297 31 699 700 705 +1298 6 701 700 704 +1299 32 701 700 705 +1300 33 704 700 705 +1301 9 700 701 702 +1302 10 700 701 718 +1303 11 702 701 718 +1304 34 700 705 706 +1305 34 700 705 707 +1306 33 700 705 709 +1307 35 706 705 707 +1308 8 706 705 709 +1309 8 707 705 709 +1310 12 705 706 708 +1311 13 705 706 710 +1312 13 705 706 711 +1313 14 708 706 710 +1314 14 708 706 711 +1315 15 710 706 711 +1316 13 705 707 712 +1317 13 705 707 713 +1318 13 705 707 714 +1319 15 712 707 713 +1320 15 712 707 714 +1321 15 713 707 714 +1322 14 706 708 715 +1323 14 706 708 716 +1324 14 706 708 717 +1325 15 715 708 716 +1326 15 715 708 717 +1327 15 716 708 717 +1328 20 701 718 719 +1329 21 701 718 722 +1330 22 719 718 722 +1331 23 718 719 720 +1332 24 718 719 723 +1333 25 718 719 724 +1334 6 720 719 723 +1335 7 720 719 724 +1336 8 723 719 724 +1337 9 719 720 721 +1338 10 719 720 738 +1339 11 721 720 738 +1340 36 719 724 725 +1341 13 719 724 731 +1342 13 719 724 732 +1343 37 725 724 731 +1344 37 725 724 732 +1345 15 731 724 732 +1346 38 724 725 726 +1347 38 724 725 727 +1348 39 726 725 727 +1349 39 725 726 728 +1350 40 725 726 733 +1351 40 728 726 733 +1352 39 725 727 729 +1353 40 725 727 734 +1354 40 729 727 734 +1355 39 726 728 730 +1356 40 726 728 735 +1357 40 730 728 735 +1358 39 727 729 730 +1359 40 727 729 736 +1360 40 730 729 736 +1361 39 728 730 729 +1362 40 728 730 737 +1363 40 729 730 737 +1364 20 720 738 739 +1365 21 720 738 742 +1366 22 739 738 742 +1367 23 738 739 740 +1368 24 738 739 743 +1369 25 738 739 744 +1370 6 740 739 743 +1371 7 740 739 744 +1372 8 743 739 744 +1373 9 739 740 741 +1374 10 739 740 748 +1375 11 741 740 748 +1376 13 739 744 745 +1377 13 739 744 746 +1378 13 739 744 747 +1379 15 745 744 746 +1380 15 745 744 747 +1381 15 746 744 747 +1382 51 740 748 749 +1383 21 740 748 752 +1384 52 749 748 752 +1385 53 748 749 750 +1386 54 748 749 753 +1387 54 748 749 754 +1388 55 750 749 753 +1389 55 750 749 754 +1390 56 753 749 754 +1391 57 749 750 751 +1392 58 749 750 755 +1393 11 751 750 755 +1394 20 750 755 756 +1395 21 750 755 759 +1396 22 756 755 759 +1397 23 755 756 757 +1398 24 755 756 760 +1399 25 755 756 761 +1400 6 757 756 760 +1401 7 757 756 761 +1402 8 760 756 761 +1403 9 756 757 758 +1404 10 756 757 777 +1405 11 758 757 777 +1406 12 756 761 762 +1407 13 756 761 766 +1408 13 756 761 767 +1409 14 762 761 766 +1410 14 762 761 767 +1411 15 766 761 767 +1412 41 761 762 763 +1413 14 761 762 768 +1414 14 761 762 769 +1415 14 763 762 768 +1416 14 763 762 769 +1417 15 768 762 769 +1418 41 762 763 764 +1419 14 762 763 770 +1420 14 762 763 771 +1421 14 764 763 770 +1422 14 764 763 771 +1423 15 770 763 771 +1424 42 763 764 765 +1425 14 763 764 772 +1426 14 763 764 773 +1427 43 765 764 772 +1428 43 765 764 773 +1429 15 772 764 773 +1430 44 764 765 774 +1431 44 764 765 775 +1432 44 764 765 776 +1433 45 774 765 775 +1434 45 774 765 776 +1435 45 775 765 776 +1436 20 757 777 778 +1437 21 757 777 781 +1438 22 778 777 781 +1439 23 777 778 779 +1440 24 777 778 782 +1441 25 777 778 783 +1442 6 779 778 782 +1443 7 779 778 783 +1444 8 782 778 783 +1445 9 778 779 780 +1446 10 778 779 794 +1447 11 780 779 794 +1448 12 778 783 784 +1449 13 778 783 788 +1450 13 778 783 789 +1451 14 784 783 788 +1452 14 784 783 789 +1453 15 788 783 789 +1454 26 783 784 785 +1455 14 783 784 790 +1456 14 783 784 791 +1457 27 785 784 790 +1458 27 785 784 791 +1459 15 790 784 791 +1460 28 784 785 786 +1461 29 784 785 787 +1462 11 786 785 787 +1463 21 785 787 792 +1464 21 785 787 793 +1465 30 792 787 793 +1466 20 779 794 795 +1467 21 779 794 798 +1468 22 795 794 798 +1469 23 794 795 796 +1470 24 794 795 799 +1471 25 794 795 800 +1472 6 796 795 799 +1473 7 796 795 800 +1474 8 799 795 800 +1475 9 795 796 797 +1476 10 795 796 813 +1477 11 797 796 813 +1478 50 795 800 801 +1479 13 795 800 804 +1480 13 795 800 805 +1481 13 801 800 804 +1482 13 801 800 805 +1483 15 804 800 805 +1484 35 800 801 802 +1485 35 800 801 803 +1486 8 800 801 806 +1487 35 802 801 803 +1488 8 802 801 806 +1489 8 803 801 806 +1490 13 801 802 807 +1491 13 801 802 808 +1492 13 801 802 809 +1493 15 807 802 808 +1494 15 807 802 809 +1495 15 808 802 809 +1496 13 801 803 810 +1497 13 801 803 811 +1498 13 801 803 812 +1499 15 810 803 811 +1500 15 810 803 812 +1501 15 811 803 812 +1502 20 796 813 814 +1503 21 796 813 817 +1504 22 814 813 817 +1505 23 813 814 815 +1506 24 813 814 818 +1507 25 813 814 819 +1508 6 815 814 818 +1509 7 815 814 819 +1510 8 818 814 819 +1511 9 814 815 816 +1512 10 814 815 828 +1513 11 816 815 828 +1514 12 814 819 820 +1515 13 814 819 824 +1516 13 814 819 825 +1517 14 820 819 824 +1518 14 820 819 825 +1519 15 824 819 825 +1520 59 819 820 821 +1521 14 819 820 826 +1522 14 819 820 827 +1523 60 821 820 826 +1524 60 821 820 827 +1525 15 826 820 827 +1526 61 820 821 822 +1527 61 820 821 823 +1528 62 822 821 823 +1529 20 815 828 829 +1530 21 815 828 832 +1531 22 829 828 832 +1532 23 828 829 830 +1533 24 828 829 833 +1534 25 828 829 834 +1535 6 830 829 833 +1536 7 830 829 834 +1537 8 833 829 834 +1538 9 829 830 831 +1539 10 829 830 840 +1540 11 831 830 840 +1541 85 829 834 835 +1542 13 829 834 838 +1543 13 829 834 839 +1544 60 835 834 838 +1545 60 835 834 839 +1546 15 838 834 839 +1547 61 834 835 836 +1548 61 834 835 837 +1549 62 836 835 837 +1550 51 830 840 841 +1551 21 830 840 844 +1552 52 841 840 844 +1553 53 840 841 842 +1554 54 840 841 845 +1555 54 840 841 846 +1556 55 842 841 845 +1557 55 842 841 846 +1558 56 845 841 846 +1559 57 841 842 843 +1560 58 841 842 847 +1561 11 843 842 847 +1562 20 842 847 848 +1563 21 842 847 851 +1564 22 848 847 851 +1565 23 847 848 849 +1566 24 847 848 852 +1567 25 847 848 853 +1568 6 849 848 852 +1569 7 849 848 853 +1570 8 852 848 853 +1571 9 848 849 850 +1572 10 848 849 871 +1573 11 850 849 871 +1574 12 848 853 854 +1575 13 848 853 860 +1576 13 848 853 861 +1577 14 854 853 860 +1578 14 854 853 861 +1579 15 860 853 861 +1580 41 853 854 855 +1581 14 853 854 862 +1582 14 853 854 863 +1583 14 855 854 862 +1584 14 855 854 863 +1585 15 862 854 863 +1586 87 854 855 856 +1587 14 854 855 864 +1588 14 854 855 865 +1589 88 856 855 864 +1590 88 856 855 865 +1591 15 864 855 865 +1592 89 855 856 857 +1593 90 855 856 866 +1594 91 857 856 866 +1595 92 856 857 858 +1596 92 856 857 859 +1597 92 858 857 859 +1598 91 857 858 867 +1599 91 857 858 868 +1600 93 867 858 868 +1601 91 857 859 869 +1602 91 857 859 870 +1603 93 869 859 870 +1604 20 849 871 872 +1605 21 849 871 875 +1606 22 872 871 875 +1607 23 871 872 873 +1608 24 871 872 876 +1609 31 871 872 877 +1610 6 873 872 876 +1611 32 873 872 877 +1612 33 876 872 877 +1613 9 872 873 874 +1614 10 872 873 885 +1615 11 874 873 885 +1616 46 872 877 878 +1617 34 872 877 879 +1618 33 872 877 880 +1619 47 878 877 879 +1620 48 878 877 880 +1621 8 879 877 880 +1622 49 877 878 881 +1623 13 877 879 882 +1624 13 877 879 883 +1625 13 877 879 884 +1626 15 882 879 883 +1627 15 882 879 884 +1628 15 883 879 884 +1629 20 873 885 886 +1630 21 873 885 889 +1631 22 886 885 889 +1632 23 885 886 887 +1633 24 885 886 890 +1634 25 885 886 891 +1635 6 887 886 890 +1636 7 887 886 891 +1637 8 890 886 891 +1638 9 886 887 888 +1639 10 886 887 904 +1640 11 888 887 904 +1641 50 886 891 892 +1642 13 886 891 895 +1643 13 886 891 896 +1644 13 892 891 895 +1645 13 892 891 896 +1646 15 895 891 896 +1647 35 891 892 893 +1648 35 891 892 894 +1649 8 891 892 897 +1650 35 893 892 894 +1651 8 893 892 897 +1652 8 894 892 897 +1653 13 892 893 898 +1654 13 892 893 899 +1655 13 892 893 900 +1656 15 898 893 899 +1657 15 898 893 900 +1658 15 899 893 900 +1659 13 892 894 901 +1660 13 892 894 902 +1661 13 892 894 903 +1662 15 901 894 902 +1663 15 901 894 903 +1664 15 902 894 903 +1665 20 887 904 905 +1666 21 887 904 908 +1667 22 905 904 908 +1668 23 904 905 906 +1669 24 904 905 909 +1670 25 904 905 910 +1671 6 906 905 909 +1672 7 906 905 910 +1673 8 909 905 910 +1674 9 905 906 907 +1675 10 905 906 915 +1676 11 907 906 915 +1677 82 905 910 911 +1678 13 905 910 912 +1679 13 905 910 913 +1680 83 911 910 912 +1681 83 911 910 913 +1682 15 912 910 913 +1683 84 910 911 914 +1684 20 906 915 916 +1685 21 906 915 919 +1686 22 916 915 919 +1687 23 915 916 917 +1688 24 915 916 920 +1689 25 915 916 921 +1690 6 917 916 920 +1691 7 917 916 921 +1692 8 920 916 921 +1693 9 916 917 918 +1694 10 916 917 927 +1695 11 918 917 927 +1696 85 916 921 922 +1697 13 916 921 925 +1698 13 916 921 926 +1699 60 922 921 925 +1700 60 922 921 926 +1701 15 925 921 926 +1702 61 921 922 923 +1703 61 921 922 924 +1704 62 923 922 924 +1705 20 917 927 928 +1706 21 917 927 931 +1707 22 928 927 931 +1708 23 927 928 929 +1709 24 927 928 932 +1710 25 927 928 933 +1711 6 929 928 932 +1712 7 929 928 933 +1713 8 932 928 933 +1714 9 928 929 930 +1715 10 928 929 948 +1716 11 930 929 948 +1717 36 928 933 934 +1718 13 928 933 941 +1719 13 928 933 942 +1720 37 934 933 941 +1721 37 934 933 942 +1722 15 941 933 942 +1723 38 933 934 935 +1724 38 933 934 936 +1725 39 935 934 936 +1726 39 934 935 937 +1727 40 934 935 943 +1728 40 937 935 943 +1729 39 934 936 938 +1730 40 934 936 944 +1731 40 938 936 944 +1732 39 935 937 939 +1733 40 935 937 945 +1734 40 939 937 945 +1735 39 936 938 939 +1736 40 936 938 946 +1737 40 939 938 946 +1738 39 937 939 938 +1739 94 937 939 940 +1740 94 938 939 940 +1741 95 939 940 947 +1742 20 929 948 949 +1743 21 929 948 952 +1744 22 949 948 952 +1745 23 948 949 950 +1746 24 948 949 953 +1747 25 948 949 954 +1748 6 950 949 953 +1749 7 950 949 954 +1750 8 953 949 954 +1751 9 949 950 951 +1752 10 949 950 962 +1753 11 951 950 962 +1754 86 949 954 955 +1755 13 949 954 958 +1756 13 949 954 959 +1757 27 955 954 958 +1758 27 955 954 959 +1759 15 958 954 959 +1760 28 954 955 956 +1761 29 954 955 957 +1762 11 956 955 957 +1763 21 955 957 960 +1764 21 955 957 961 +1765 30 960 957 961 +1766 20 950 962 963 +1767 21 950 962 966 +1768 22 963 962 966 +1769 23 962 963 964 +1770 24 962 963 967 +1771 31 962 963 968 +1772 6 964 963 967 +1773 32 964 963 968 +1774 33 967 963 968 +1775 9 963 964 965 +1776 10 963 964 981 +1777 11 965 964 981 +1778 34 963 968 969 +1779 34 963 968 970 +1780 33 963 968 972 +1781 35 969 968 970 +1782 8 969 968 972 +1783 8 970 968 972 +1784 12 968 969 971 +1785 13 968 969 973 +1786 13 968 969 974 +1787 14 971 969 973 +1788 14 971 969 974 +1789 15 973 969 974 +1790 13 968 970 975 +1791 13 968 970 976 +1792 13 968 970 977 +1793 15 975 970 976 +1794 15 975 970 977 +1795 15 976 970 977 +1796 14 969 971 978 +1797 14 969 971 979 +1798 14 969 971 980 +1799 15 978 971 979 +1800 15 978 971 980 +1801 15 979 971 980 +1802 20 964 981 982 +1803 21 964 981 985 +1804 22 982 981 985 +1805 23 981 982 983 +1806 24 981 982 986 +1807 25 981 982 987 +1808 6 983 982 986 +1809 7 983 982 987 +1810 8 986 982 987 +1811 9 982 983 984 +1812 10 982 983 998 +1813 11 984 983 998 +1814 12 982 987 988 +1815 13 982 987 992 +1816 13 982 987 993 +1817 14 988 987 992 +1818 14 988 987 993 +1819 15 992 987 993 +1820 26 987 988 989 +1821 14 987 988 994 +1822 14 987 988 995 +1823 27 989 988 994 +1824 27 989 988 995 +1825 15 994 988 995 +1826 28 988 989 990 +1827 29 988 989 991 +1828 11 990 989 991 +1829 21 989 991 996 +1830 21 989 991 997 +1831 30 996 991 997 +1832 20 983 998 999 +1833 21 983 998 1002 +1834 22 999 998 1002 +1835 23 998 999 1000 +1836 24 998 999 1003 +1837 25 998 999 1004 +1838 6 1000 999 1003 +1839 7 1000 999 1004 +1840 8 1003 999 1004 +1841 9 999 1000 1001 +1842 10 999 1000 1020 +1843 11 1001 1000 1020 +1844 12 999 1004 1005 +1845 13 999 1004 1009 +1846 13 999 1004 1010 +1847 14 1005 1004 1009 +1848 14 1005 1004 1010 +1849 15 1009 1004 1010 +1850 41 1004 1005 1006 +1851 14 1004 1005 1011 +1852 14 1004 1005 1012 +1853 14 1006 1005 1011 +1854 14 1006 1005 1012 +1855 15 1011 1005 1012 +1856 41 1005 1006 1007 +1857 14 1005 1006 1013 +1858 14 1005 1006 1014 +1859 14 1007 1006 1013 +1860 14 1007 1006 1014 +1861 15 1013 1006 1014 +1862 42 1006 1007 1008 +1863 14 1006 1007 1015 +1864 14 1006 1007 1016 +1865 43 1008 1007 1015 +1866 43 1008 1007 1016 +1867 15 1015 1007 1016 +1868 44 1007 1008 1017 +1869 44 1007 1008 1018 +1870 44 1007 1008 1019 +1871 45 1017 1008 1018 +1872 45 1017 1008 1019 +1873 45 1018 1008 1019 +1874 20 1000 1020 1021 +1875 21 1000 1020 1024 +1876 22 1021 1020 1024 +1877 23 1020 1021 1022 +1878 24 1020 1021 1025 +1879 25 1020 1021 1026 +1880 6 1022 1021 1025 +1881 7 1022 1021 1026 +1882 8 1025 1021 1026 +1883 9 1021 1022 1023 +1884 10 1021 1022 1035 +1885 11 1023 1022 1035 +1886 12 1021 1026 1027 +1887 13 1021 1026 1031 +1888 13 1021 1026 1032 +1889 14 1027 1026 1031 +1890 14 1027 1026 1032 +1891 15 1031 1026 1032 +1892 59 1026 1027 1028 +1893 14 1026 1027 1033 +1894 14 1026 1027 1034 +1895 60 1028 1027 1033 +1896 60 1028 1027 1034 +1897 15 1033 1027 1034 +1898 61 1027 1028 1029 +1899 61 1027 1028 1030 +1900 62 1029 1028 1030 +1901 20 1022 1035 1036 +1902 21 1022 1035 1039 +1903 22 1036 1035 1039 +1904 23 1035 1036 1037 +1905 24 1035 1036 1040 +1906 25 1035 1036 1041 +1907 6 1037 1036 1040 +1908 7 1037 1036 1041 +1909 8 1040 1036 1041 +1910 9 1036 1037 1038 +1911 10 1036 1037 1046 +1912 11 1038 1037 1046 +1913 82 1036 1041 1042 +1914 13 1036 1041 1043 +1915 13 1036 1041 1044 +1916 83 1042 1041 1043 +1917 83 1042 1041 1044 +1918 15 1043 1041 1044 +1919 84 1041 1042 1045 +1920 20 1037 1046 1047 +1921 21 1037 1046 1050 +1922 22 1047 1046 1050 +1923 23 1046 1047 1048 +1924 24 1046 1047 1051 +1925 31 1046 1047 1052 +1926 6 1048 1047 1051 +1927 32 1048 1047 1052 +1928 33 1051 1047 1052 +1929 9 1047 1048 1049 +1930 10 1047 1048 1060 +1931 11 1049 1048 1060 +1932 46 1047 1052 1053 +1933 34 1047 1052 1054 +1934 33 1047 1052 1055 +1935 47 1053 1052 1054 +1936 48 1053 1052 1055 +1937 8 1054 1052 1055 +1938 49 1052 1053 1056 +1939 13 1052 1054 1057 +1940 13 1052 1054 1058 +1941 13 1052 1054 1059 +1942 15 1057 1054 1058 +1943 15 1057 1054 1059 +1944 15 1058 1054 1059 +1945 20 1048 1060 1061 +1946 21 1048 1060 1064 +1947 22 1061 1060 1064 +1948 23 1060 1061 1062 +1949 24 1060 1061 1065 +1950 25 1060 1061 1066 +1951 6 1062 1061 1065 +1952 7 1062 1061 1066 +1953 8 1065 1061 1066 +1954 9 1061 1062 1063 +1955 10 1061 1062 1079 +1956 11 1063 1062 1079 +1957 50 1061 1066 1067 +1958 13 1061 1066 1070 +1959 13 1061 1066 1071 +1960 13 1067 1066 1070 +1961 13 1067 1066 1071 +1962 15 1070 1066 1071 +1963 35 1066 1067 1068 +1964 35 1066 1067 1069 +1965 8 1066 1067 1072 +1966 35 1068 1067 1069 +1967 8 1068 1067 1072 +1968 8 1069 1067 1072 +1969 13 1067 1068 1073 +1970 13 1067 1068 1074 +1971 13 1067 1068 1075 +1972 15 1073 1068 1074 +1973 15 1073 1068 1075 +1974 15 1074 1068 1075 +1975 13 1067 1069 1076 +1976 13 1067 1069 1077 +1977 13 1067 1069 1078 +1978 15 1076 1069 1077 +1979 15 1076 1069 1078 +1980 15 1077 1069 1078 +1981 20 1062 1079 1080 +1982 21 1062 1079 1083 +1983 22 1080 1079 1083 +1984 23 1079 1080 1081 +1985 24 1079 1080 1084 +1986 25 1079 1080 1085 +1987 6 1081 1080 1084 +1988 7 1081 1080 1085 +1989 8 1084 1080 1085 +1990 9 1080 1081 1082 +1991 10 1080 1081 1097 +1992 11 1082 1081 1097 +1993 96 1080 1085 1086 +1994 13 1080 1085 1091 +1995 13 1080 1085 1092 +1996 97 1086 1085 1091 +1997 97 1086 1085 1092 +1998 15 1091 1085 1092 +1999 98 1085 1086 1087 +2000 99 1085 1086 1088 +2001 100 1087 1086 1088 +2002 101 1086 1087 1089 +2003 102 1086 1087 1093 +2004 103 1089 1087 1093 +2005 100 1086 1088 1090 +2006 104 1086 1088 1094 +2007 105 1090 1088 1094 +2008 106 1087 1089 1090 +2009 107 1087 1089 1095 +2010 107 1090 1089 1095 +2011 101 1088 1090 1089 +2012 102 1088 1090 1096 +2013 103 1089 1090 1096 +2014 20 1081 1097 1098 +2015 21 1081 1097 1101 +2016 22 1098 1097 1101 +2017 23 1097 1098 1099 +2018 24 1097 1098 1102 +2019 25 1097 1098 1103 +2020 6 1099 1098 1102 +2021 7 1099 1098 1103 +2022 8 1102 1098 1103 +2023 9 1098 1099 1100 +2024 10 1098 1099 1116 +2025 11 1100 1099 1116 +2026 50 1098 1103 1104 +2027 13 1098 1103 1107 +2028 13 1098 1103 1108 +2029 13 1104 1103 1107 +2030 13 1104 1103 1108 +2031 15 1107 1103 1108 +2032 35 1103 1104 1105 +2033 35 1103 1104 1106 +2034 8 1103 1104 1109 +2035 35 1105 1104 1106 +2036 8 1105 1104 1109 +2037 8 1106 1104 1109 +2038 13 1104 1105 1110 +2039 13 1104 1105 1111 +2040 13 1104 1105 1112 +2041 15 1110 1105 1111 +2042 15 1110 1105 1112 +2043 15 1111 1105 1112 +2044 13 1104 1106 1113 +2045 13 1104 1106 1114 +2046 13 1104 1106 1115 +2047 15 1113 1106 1114 +2048 15 1113 1106 1115 +2049 15 1114 1106 1115 +2050 20 1099 1116 1117 +2051 21 1099 1116 1120 +2052 22 1117 1116 1120 +2053 23 1116 1117 1118 +2054 24 1116 1117 1121 +2055 31 1116 1117 1122 +2056 6 1118 1117 1121 +2057 32 1118 1117 1122 +2058 33 1121 1117 1122 +2059 9 1117 1118 1119 +2060 10 1117 1118 1132 +2061 11 1119 1118 1132 +2062 34 1117 1122 1123 +2063 34 1117 1122 1124 +2064 33 1117 1122 1125 +2065 35 1123 1122 1124 +2066 8 1123 1122 1125 +2067 8 1124 1122 1125 +2068 13 1122 1123 1126 +2069 13 1122 1123 1127 +2070 13 1122 1123 1128 +2071 15 1126 1123 1127 +2072 15 1126 1123 1128 +2073 15 1127 1123 1128 +2074 13 1122 1124 1129 +2075 13 1122 1124 1130 +2076 13 1122 1124 1131 +2077 15 1129 1124 1130 +2078 15 1129 1124 1131 +2079 15 1130 1124 1131 +2080 20 1118 1132 1133 +2081 21 1118 1132 1136 +2082 22 1133 1132 1136 +2083 23 1132 1133 1134 +2084 24 1132 1133 1137 +2085 25 1132 1133 1138 +2086 6 1134 1133 1137 +2087 7 1134 1133 1138 +2088 8 1137 1133 1138 +2089 9 1133 1134 1135 +2090 10 1133 1134 1151 +2091 11 1135 1134 1151 +2092 50 1133 1138 1139 +2093 13 1133 1138 1142 +2094 13 1133 1138 1143 +2095 13 1139 1138 1142 +2096 13 1139 1138 1143 +2097 15 1142 1138 1143 +2098 35 1138 1139 1140 +2099 35 1138 1139 1141 +2100 8 1138 1139 1144 +2101 35 1140 1139 1141 +2102 8 1140 1139 1144 +2103 8 1141 1139 1144 +2104 13 1139 1140 1145 +2105 13 1139 1140 1146 +2106 13 1139 1140 1147 +2107 15 1145 1140 1146 +2108 15 1145 1140 1147 +2109 15 1146 1140 1147 +2110 13 1139 1141 1148 +2111 13 1139 1141 1149 +2112 13 1139 1141 1150 +2113 15 1148 1141 1149 +2114 15 1148 1141 1150 +2115 15 1149 1141 1150 +2116 20 1134 1151 1152 +2117 21 1134 1151 1155 +2118 22 1152 1151 1155 +2119 23 1151 1152 1153 +2120 24 1151 1152 1156 +2121 25 1151 1152 1157 +2122 6 1153 1152 1156 +2123 7 1153 1152 1157 +2124 8 1156 1152 1157 +2125 9 1152 1153 1154 +2126 10 1152 1153 1175 +2127 11 1154 1153 1175 +2128 12 1152 1157 1158 +2129 13 1152 1157 1164 +2130 13 1152 1157 1165 +2131 14 1158 1157 1164 +2132 14 1158 1157 1165 +2133 15 1164 1157 1165 +2134 41 1157 1158 1159 +2135 14 1157 1158 1166 +2136 14 1157 1158 1167 +2137 14 1159 1158 1166 +2138 14 1159 1158 1167 +2139 15 1166 1158 1167 +2140 87 1158 1159 1160 +2141 14 1158 1159 1168 +2142 14 1158 1159 1169 +2143 88 1160 1159 1168 +2144 88 1160 1159 1169 +2145 15 1168 1159 1169 +2146 89 1159 1160 1161 +2147 90 1159 1160 1170 +2148 91 1161 1160 1170 +2149 92 1160 1161 1162 +2150 92 1160 1161 1163 +2151 92 1162 1161 1163 +2152 91 1161 1162 1171 +2153 91 1161 1162 1172 +2154 93 1171 1162 1172 +2155 91 1161 1163 1173 +2156 91 1161 1163 1174 +2157 93 1173 1163 1174 +2158 20 1153 1175 1176 +2159 21 1153 1175 1179 +2160 22 1176 1175 1179 +2161 23 1175 1176 1177 +2162 24 1175 1176 1180 +2163 25 1175 1176 1181 +2164 6 1177 1176 1180 +2165 7 1177 1176 1181 +2166 8 1180 1176 1181 +2167 9 1176 1177 1178 +2168 10 1176 1177 1194 +2169 11 1178 1177 1194 +2170 50 1176 1181 1182 +2171 13 1176 1181 1185 +2172 13 1176 1181 1186 +2173 13 1182 1181 1185 +2174 13 1182 1181 1186 +2175 15 1185 1181 1186 +2176 35 1181 1182 1183 +2177 35 1181 1182 1184 +2178 8 1181 1182 1187 +2179 35 1183 1182 1184 +2180 8 1183 1182 1187 +2181 8 1184 1182 1187 +2182 13 1182 1183 1188 +2183 13 1182 1183 1189 +2184 13 1182 1183 1190 +2185 15 1188 1183 1189 +2186 15 1188 1183 1190 +2187 15 1189 1183 1190 +2188 13 1182 1184 1191 +2189 13 1182 1184 1192 +2190 13 1182 1184 1193 +2191 15 1191 1184 1192 +2192 15 1191 1184 1193 +2193 15 1192 1184 1193 +2194 20 1177 1194 1195 +2195 21 1177 1194 1198 +2196 22 1195 1194 1198 +2197 23 1194 1195 1196 +2198 24 1194 1195 1199 +2199 25 1194 1195 1200 +2200 6 1196 1195 1199 +2201 7 1196 1195 1200 +2202 8 1199 1195 1200 +2203 9 1195 1196 1197 +2204 10 1195 1196 1218 +2205 11 1197 1196 1218 +2206 12 1195 1200 1201 +2207 13 1195 1200 1207 +2208 13 1195 1200 1208 +2209 14 1201 1200 1207 +2210 14 1201 1200 1208 +2211 15 1207 1200 1208 +2212 41 1200 1201 1202 +2213 14 1200 1201 1209 +2214 14 1200 1201 1210 +2215 14 1202 1201 1209 +2216 14 1202 1201 1210 +2217 15 1209 1201 1210 +2218 87 1201 1202 1203 +2219 14 1201 1202 1211 +2220 14 1201 1202 1212 +2221 88 1203 1202 1211 +2222 88 1203 1202 1212 +2223 15 1211 1202 1212 +2224 89 1202 1203 1204 +2225 90 1202 1203 1213 +2226 91 1204 1203 1213 +2227 92 1203 1204 1205 +2228 92 1203 1204 1206 +2229 92 1205 1204 1206 +2230 91 1204 1205 1214 +2231 91 1204 1205 1215 +2232 93 1214 1205 1215 +2233 91 1204 1206 1216 +2234 91 1204 1206 1217 +2235 93 1216 1206 1217 +2236 51 1196 1218 1219 +2237 21 1196 1218 1222 +2238 52 1219 1218 1222 +2239 53 1218 1219 1220 +2240 54 1218 1219 1223 +2241 54 1218 1219 1224 +2242 55 1220 1219 1223 +2243 55 1220 1219 1224 +2244 56 1223 1219 1224 +2245 57 1219 1220 1221 +2246 58 1219 1220 1225 +2247 11 1221 1220 1225 +2248 51 1220 1225 1226 +2249 21 1220 1225 1229 +2250 52 1226 1225 1229 +2251 108 1225 1226 1227 +2252 54 1225 1226 1230 +2253 54 1225 1226 1231 +2254 109 1227 1226 1230 +2255 109 1227 1226 1231 +2256 56 1230 1226 1231 +2257 110 1226 1227 1228 +2258 110 1226 1227 1232 +2259 62 1228 1227 1232 +2260 111 1234 1233 1235 +2261 111 1237 1236 1238 +2262 111 1240 1239 1241 +2263 111 1243 1242 1244 +2264 111 1246 1245 1247 +2265 111 1249 1248 1250 +2266 111 1252 1251 1253 +2267 111 1255 1254 1256 +2268 111 1258 1257 1259 +2269 111 1261 1260 1262 +2270 111 1264 1263 1265 +2271 111 1267 1266 1268 +2272 111 1270 1269 1271 +2273 111 1273 1272 1274 +2274 111 1276 1275 1277 +2275 111 1279 1278 1280 +2276 111 1282 1281 1283 +2277 111 1285 1284 1286 +2278 111 1288 1287 1289 +2279 111 1291 1290 1292 +2280 111 1294 1293 1295 +2281 111 1297 1296 1298 +2282 111 1300 1299 1301 +2283 111 1303 1302 1304 +2284 111 1306 1305 1307 +2285 111 1309 1308 1310 +2286 111 1312 1311 1313 +2287 111 1315 1314 1316 +2288 111 1318 1317 1319 +2289 111 1321 1320 1322 +2290 111 1324 1323 1325 +2291 111 1327 1326 1328 +2292 111 1330 1329 1331 +2293 111 1333 1332 1334 +2294 111 1336 1335 1337 +2295 111 1339 1338 1340 +2296 111 1342 1341 1343 +2297 111 1345 1344 1346 +2298 111 1348 1347 1349 +2299 111 1351 1350 1352 +2300 111 1354 1353 1355 +2301 111 1357 1356 1358 +2302 111 1360 1359 1361 +2303 111 1363 1362 1364 +2304 111 1366 1365 1367 +2305 111 1369 1368 1370 +2306 111 1372 1371 1373 +2307 111 1375 1374 1376 +2308 111 1378 1377 1379 +2309 111 1381 1380 1382 +2310 111 1384 1383 1385 +2311 111 1387 1386 1388 +2312 111 1390 1389 1391 +2313 111 1393 1392 1394 +2314 111 1396 1395 1397 +2315 111 1399 1398 1400 +2316 111 1402 1401 1403 +2317 111 1405 1404 1406 +2318 111 1408 1407 1409 +2319 111 1411 1410 1412 +2320 111 1414 1413 1415 +2321 111 1417 1416 1418 +2322 111 1420 1419 1421 +2323 111 1423 1422 1424 +2324 111 1426 1425 1427 +2325 111 1429 1428 1430 +2326 111 1432 1431 1433 +2327 111 1435 1434 1436 +2328 111 1438 1437 1439 +2329 111 1441 1440 1442 +2330 111 1444 1443 1445 +2331 111 1447 1446 1448 +2332 111 1450 1449 1451 +2333 111 1453 1452 1454 +2334 111 1456 1455 1457 +2335 111 1459 1458 1460 +2336 111 1462 1461 1463 +2337 111 1465 1464 1466 +2338 111 1468 1467 1469 +2339 111 1471 1470 1472 +2340 111 1474 1473 1475 +2341 111 1477 1476 1478 +2342 111 1480 1479 1481 +2343 111 1483 1482 1484 +2344 111 1486 1485 1487 +2345 111 1489 1488 1490 +2346 111 1492 1491 1493 +2347 111 1495 1494 1496 +2348 111 1498 1497 1499 +2349 111 1501 1500 1502 +2350 111 1504 1503 1505 +2351 111 1507 1506 1508 +2352 111 1510 1509 1511 +2353 111 1513 1512 1514 +2354 111 1516 1515 1517 +2355 111 1519 1518 1520 +2356 111 1522 1521 1523 +2357 111 1525 1524 1526 +2358 111 1528 1527 1529 +2359 111 1531 1530 1532 +2360 111 1534 1533 1535 +2361 111 1537 1536 1538 +2362 111 1540 1539 1541 +2363 111 1543 1542 1544 +2364 111 1546 1545 1547 +2365 111 1549 1548 1550 +2366 111 1552 1551 1553 +2367 111 1555 1554 1556 +2368 111 1558 1557 1559 +2369 111 1561 1560 1562 +2370 111 1564 1563 1565 +2371 111 1567 1566 1568 +2372 111 1570 1569 1571 +2373 111 1573 1572 1574 +2374 111 1576 1575 1577 +2375 111 1579 1578 1580 +2376 111 1582 1581 1583 +2377 111 1585 1584 1586 +2378 111 1588 1587 1589 +2379 111 1591 1590 1592 +2380 111 1594 1593 1595 +2381 111 1597 1596 1598 +2382 111 1600 1599 1601 +2383 111 1603 1602 1604 +2384 111 1606 1605 1607 +2385 111 1609 1608 1610 +2386 111 1612 1611 1613 +2387 111 1615 1614 1616 +2388 111 1618 1617 1619 +2389 111 1621 1620 1622 +2390 111 1624 1623 1625 +2391 111 1627 1626 1628 +2392 111 1630 1629 1631 +2393 111 1633 1632 1634 +2394 111 1636 1635 1637 +2395 111 1639 1638 1640 +2396 111 1642 1641 1643 +2397 111 1645 1644 1646 +2398 111 1648 1647 1649 +2399 111 1651 1650 1652 +2400 111 1654 1653 1655 +2401 111 1657 1656 1658 +2402 111 1660 1659 1661 +2403 111 1663 1662 1664 +2404 111 1666 1665 1667 +2405 111 1669 1668 1670 +2406 111 1672 1671 1673 +2407 111 1675 1674 1676 +2408 111 1678 1677 1679 +2409 111 1681 1680 1682 +2410 111 1684 1683 1685 +2411 111 1687 1686 1688 +2412 111 1690 1689 1691 +2413 111 1693 1692 1694 +2414 111 1696 1695 1697 +2415 111 1699 1698 1700 +2416 111 1702 1701 1703 +2417 111 1705 1704 1706 +2418 111 1708 1707 1709 +2419 111 1711 1710 1712 +2420 111 1714 1713 1715 +2421 111 1717 1716 1718 +2422 111 1720 1719 1721 +2423 111 1723 1722 1724 +2424 111 1726 1725 1727 +2425 111 1729 1728 1730 +2426 111 1732 1731 1733 +2427 111 1735 1734 1736 +2428 111 1738 1737 1739 +2429 111 1741 1740 1742 +2430 111 1744 1743 1745 +2431 111 1747 1746 1748 +2432 111 1750 1749 1751 +2433 111 1753 1752 1754 +2434 111 1756 1755 1757 +2435 111 1759 1758 1760 +2436 111 1762 1761 1763 +2437 111 1765 1764 1766 +2438 111 1768 1767 1769 +2439 111 1771 1770 1772 +2440 111 1774 1773 1775 +2441 111 1777 1776 1778 +2442 111 1780 1779 1781 +2443 111 1783 1782 1784 +2444 111 1786 1785 1787 +2445 111 1789 1788 1790 +2446 111 1792 1791 1793 +2447 111 1795 1794 1796 +2448 111 1798 1797 1799 +2449 111 1801 1800 1802 +2450 111 1804 1803 1805 +2451 111 1807 1806 1808 +2452 111 1810 1809 1811 +2453 111 1813 1812 1814 +2454 111 1816 1815 1817 +2455 111 1819 1818 1820 +2456 111 1822 1821 1823 +2457 111 1825 1824 1826 +2458 111 1828 1827 1829 +2459 111 1831 1830 1832 +2460 111 1834 1833 1835 +2461 111 1837 1836 1838 +2462 111 1840 1839 1841 +2463 111 1843 1842 1844 +2464 111 1846 1845 1847 +2465 111 1849 1848 1850 +2466 111 1852 1851 1853 +2467 111 1855 1854 1856 +2468 111 1858 1857 1859 +2469 111 1861 1860 1862 +2470 111 1864 1863 1865 +2471 111 1867 1866 1868 +2472 111 1870 1869 1871 +2473 111 1873 1872 1874 +2474 111 1876 1875 1877 +2475 111 1879 1878 1880 +2476 111 1882 1881 1883 +2477 111 1885 1884 1886 +2478 111 1888 1887 1889 +2479 111 1891 1890 1892 +2480 111 1894 1893 1895 +2481 111 1897 1896 1898 +2482 111 1900 1899 1901 +2483 111 1903 1902 1904 +2484 111 1906 1905 1907 +2485 111 1909 1908 1910 +2486 111 1912 1911 1913 +2487 111 1915 1914 1916 +2488 111 1918 1917 1919 +2489 111 1921 1920 1922 +2490 111 1924 1923 1925 +2491 111 1927 1926 1928 +2492 111 1930 1929 1931 +2493 111 1933 1932 1934 +2494 111 1936 1935 1937 +2495 111 1939 1938 1940 +2496 111 1942 1941 1943 +2497 111 1945 1944 1946 +2498 111 1948 1947 1949 +2499 111 1951 1950 1952 +2500 111 1954 1953 1955 +2501 111 1957 1956 1958 +2502 111 1960 1959 1961 +2503 111 1963 1962 1964 +2504 111 1966 1965 1967 +2505 111 1969 1968 1970 +2506 111 1972 1971 1973 +2507 111 1975 1974 1976 +2508 111 1978 1977 1979 +2509 111 1981 1980 1982 +2510 111 1984 1983 1985 +2511 111 1987 1986 1988 +2512 111 1990 1989 1991 +2513 111 1993 1992 1994 +2514 111 1996 1995 1997 +2515 111 1999 1998 2000 +2516 111 2002 2001 2003 +2517 111 2005 2004 2006 +2518 111 2008 2007 2009 +2519 111 2011 2010 2012 +2520 111 2014 2013 2015 +2521 111 2017 2016 2018 +2522 111 2020 2019 2021 +2523 111 2023 2022 2024 +2524 111 2026 2025 2027 +2525 111 2029 2028 2030 +2526 111 2032 2031 2033 +2527 111 2035 2034 2036 +2528 111 2038 2037 2039 +2529 111 2041 2040 2042 +2530 111 2044 2043 2045 +2531 111 2047 2046 2048 +2532 111 2050 2049 2051 +2533 111 2053 2052 2054 +2534 111 2056 2055 2057 +2535 111 2059 2058 2060 +2536 111 2062 2061 2063 +2537 111 2065 2064 2066 +2538 111 2068 2067 2069 +2539 111 2071 2070 2072 +2540 111 2074 2073 2075 +2541 111 2077 2076 2078 +2542 111 2080 2079 2081 +2543 111 2083 2082 2084 +2544 111 2086 2085 2087 +2545 111 2089 2088 2090 +2546 111 2092 2091 2093 +2547 111 2095 2094 2096 +2548 111 2098 2097 2099 +2549 111 2101 2100 2102 +2550 111 2104 2103 2105 +2551 111 2107 2106 2108 +2552 111 2110 2109 2111 +2553 111 2113 2112 2114 +2554 111 2116 2115 2117 +2555 111 2119 2118 2120 +2556 111 2122 2121 2123 +2557 111 2125 2124 2126 +2558 111 2128 2127 2129 +2559 111 2131 2130 2132 +2560 111 2134 2133 2135 +2561 111 2137 2136 2138 +2562 111 2140 2139 2141 +2563 111 2143 2142 2144 +2564 111 2146 2145 2147 +2565 111 2149 2148 2150 +2566 111 2152 2151 2153 +2567 111 2155 2154 2156 +2568 111 2158 2157 2159 +2569 111 2161 2160 2162 +2570 111 2164 2163 2165 +2571 111 2167 2166 2168 +2572 111 2170 2169 2171 +2573 111 2173 2172 2174 +2574 111 2176 2175 2177 +2575 111 2179 2178 2180 +2576 111 2182 2181 2183 +2577 111 2185 2184 2186 +2578 111 2188 2187 2189 +2579 111 2191 2190 2192 +2580 111 2194 2193 2195 +2581 111 2197 2196 2198 +2582 111 2200 2199 2201 +2583 111 2203 2202 2204 +2584 111 2206 2205 2207 +2585 111 2209 2208 2210 +2586 111 2212 2211 2213 +2587 111 2215 2214 2216 +2588 111 2218 2217 2219 +2589 111 2221 2220 2222 +2590 111 2224 2223 2225 +2591 111 2227 2226 2228 +2592 111 2230 2229 2231 +2593 111 2233 2232 2234 +2594 111 2236 2235 2237 +2595 111 2239 2238 2240 +2596 111 2242 2241 2243 +2597 111 2245 2244 2246 +2598 111 2248 2247 2249 +2599 111 2251 2250 2252 +2600 111 2254 2253 2255 +2601 111 2257 2256 2258 +2602 111 2260 2259 2261 +2603 111 2263 2262 2264 +2604 111 2266 2265 2267 +2605 111 2269 2268 2270 +2606 111 2272 2271 2273 +2607 111 2275 2274 2276 +2608 111 2278 2277 2279 +2609 111 2281 2280 2282 +2610 111 2284 2283 2285 +2611 111 2287 2286 2288 +2612 111 2290 2289 2291 +2613 111 2293 2292 2294 +2614 111 2296 2295 2297 +2615 111 2299 2298 2300 +2616 111 2302 2301 2303 +2617 111 2305 2304 2306 +2618 111 2308 2307 2309 +2619 111 2311 2310 2312 +2620 111 2314 2313 2315 +2621 111 2317 2316 2318 +2622 111 2320 2319 2321 +2623 111 2323 2322 2324 +2624 111 2326 2325 2327 +2625 111 2329 2328 2330 +2626 111 2332 2331 2333 +2627 111 2335 2334 2336 +2628 111 2338 2337 2339 +2629 111 2341 2340 2342 +2630 111 2344 2343 2345 +2631 111 2347 2346 2348 +2632 111 2350 2349 2351 +2633 111 2353 2352 2354 +2634 111 2356 2355 2357 +2635 111 2359 2358 2360 +2636 111 2362 2361 2363 +2637 111 2365 2364 2366 +2638 111 2368 2367 2369 +2639 111 2371 2370 2372 +2640 111 2374 2373 2375 +2641 111 2377 2376 2378 +2642 111 2380 2379 2381 +2643 111 2383 2382 2384 +2644 111 2386 2385 2387 +2645 111 2389 2388 2390 +2646 111 2392 2391 2393 +2647 111 2395 2394 2396 +2648 111 2398 2397 2399 +2649 111 2401 2400 2402 +2650 111 2404 2403 2405 +2651 111 2407 2406 2408 +2652 111 2410 2409 2411 +2653 111 2413 2412 2414 +2654 111 2416 2415 2417 +2655 111 2419 2418 2420 +2656 111 2422 2421 2423 +2657 111 2425 2424 2426 +2658 111 2428 2427 2429 +2659 111 2431 2430 2432 +2660 111 2434 2433 2435 +2661 111 2437 2436 2438 +2662 111 2440 2439 2441 +2663 111 2443 2442 2444 +2664 111 2446 2445 2447 +2665 111 2449 2448 2450 +2666 111 2452 2451 2453 +2667 111 2455 2454 2456 +2668 111 2458 2457 2459 +2669 111 2461 2460 2462 +2670 111 2464 2463 2465 +2671 111 2467 2466 2468 +2672 111 2470 2469 2471 +2673 111 2473 2472 2474 +2674 111 2476 2475 2477 +2675 111 2479 2478 2480 +2676 111 2482 2481 2483 +2677 111 2485 2484 2486 +2678 111 2488 2487 2489 +2679 111 2491 2490 2492 +2680 111 2494 2493 2495 +2681 111 2497 2496 2498 +2682 111 2500 2499 2501 +2683 111 2503 2502 2504 +2684 111 2506 2505 2507 +2685 111 2509 2508 2510 +2686 111 2512 2511 2513 +2687 111 2515 2514 2516 +2688 111 2518 2517 2519 +2689 111 2521 2520 2522 +2690 111 2524 2523 2525 +2691 111 2527 2526 2528 +2692 111 2530 2529 2531 +2693 111 2533 2532 2534 +2694 111 2536 2535 2537 +2695 111 2539 2538 2540 +2696 111 2542 2541 2543 +2697 111 2545 2544 2546 +2698 111 2548 2547 2549 +2699 111 2551 2550 2552 +2700 111 2554 2553 2555 +2701 111 2557 2556 2558 +2702 111 2560 2559 2561 +2703 111 2563 2562 2564 +2704 111 2566 2565 2567 +2705 111 2569 2568 2570 +2706 111 2572 2571 2573 +2707 111 2575 2574 2576 +2708 111 2578 2577 2579 +2709 111 2581 2580 2582 +2710 111 2584 2583 2585 +2711 111 2587 2586 2588 +2712 111 2590 2589 2591 +2713 111 2593 2592 2594 +2714 111 2596 2595 2597 +2715 111 2599 2598 2600 +2716 111 2602 2601 2603 +2717 111 2605 2604 2606 +2718 111 2608 2607 2609 +2719 111 2611 2610 2612 +2720 111 2614 2613 2615 +2721 111 2617 2616 2618 +2722 111 2620 2619 2621 +2723 111 2623 2622 2624 +2724 111 2626 2625 2627 +2725 111 2629 2628 2630 +2726 111 2632 2631 2633 +2727 111 2635 2634 2636 +2728 111 2638 2637 2639 +2729 111 2641 2640 2642 +2730 111 2644 2643 2645 +2731 111 2647 2646 2648 +2732 111 2650 2649 2651 +2733 111 2653 2652 2654 +2734 111 2656 2655 2657 +2735 111 2659 2658 2660 +2736 111 2662 2661 2663 +2737 111 2665 2664 2666 +2738 111 2668 2667 2669 +2739 111 2671 2670 2672 +2740 111 2674 2673 2675 +2741 111 2677 2676 2678 +2742 111 2680 2679 2681 +2743 111 2683 2682 2684 +2744 111 2686 2685 2687 +2745 111 2689 2688 2690 +2746 111 2692 2691 2693 +2747 111 2695 2694 2696 +2748 111 2698 2697 2699 +2749 111 2701 2700 2702 +2750 111 2704 2703 2705 +2751 111 2707 2706 2708 +2752 111 2710 2709 2711 +2753 111 2713 2712 2714 +2754 111 2716 2715 2717 +2755 111 2719 2718 2720 +2756 111 2722 2721 2723 +2757 111 2725 2724 2726 +2758 111 2728 2727 2729 +2759 111 2731 2730 2732 +2760 111 2734 2733 2735 +2761 111 2737 2736 2738 +2762 111 2740 2739 2741 +2763 111 2743 2742 2744 +2764 111 2746 2745 2747 +2765 111 2749 2748 2750 +2766 111 2752 2751 2753 +2767 111 2755 2754 2756 +2768 111 2758 2757 2759 +2769 111 2761 2760 2762 +2770 111 2764 2763 2765 +2771 111 2767 2766 2768 +2772 111 2770 2769 2771 +2773 111 2773 2772 2774 +2774 111 2776 2775 2777 +2775 111 2779 2778 2780 +2776 111 2782 2781 2783 +2777 111 2785 2784 2786 +2778 111 2788 2787 2789 +2779 111 2791 2790 2792 +2780 111 2794 2793 2795 +2781 111 2797 2796 2798 +2782 111 2800 2799 2801 +2783 111 2803 2802 2804 +2784 111 2806 2805 2807 +2785 111 2809 2808 2810 +2786 111 2812 2811 2813 +2787 111 2815 2814 2816 +2788 111 2818 2817 2819 +2789 111 2821 2820 2822 +2790 111 2824 2823 2825 +2791 111 2827 2826 2828 +2792 111 2830 2829 2831 +2793 111 2833 2832 2834 +2794 111 2836 2835 2837 +2795 111 2839 2838 2840 +2796 111 2842 2841 2843 +2797 111 2845 2844 2846 +2798 111 2848 2847 2849 +2799 111 2851 2850 2852 +2800 111 2854 2853 2855 +2801 111 2857 2856 2858 +2802 111 2860 2859 2861 +2803 111 2863 2862 2864 +2804 111 2866 2865 2867 +2805 111 2869 2868 2870 +2806 111 2872 2871 2873 +2807 111 2875 2874 2876 +2808 111 2878 2877 2879 +2809 111 2881 2880 2882 +2810 111 2884 2883 2885 +2811 111 2887 2886 2888 +2812 111 2890 2889 2891 +2813 111 2893 2892 2894 +2814 111 2896 2895 2897 +2815 111 2899 2898 2900 +2816 111 2902 2901 2903 +2817 111 2905 2904 2906 +2818 111 2908 2907 2909 +2819 111 2911 2910 2912 +2820 111 2914 2913 2915 +2821 111 2917 2916 2918 +2822 111 2920 2919 2921 +2823 111 2923 2922 2924 +2824 111 2926 2925 2927 +2825 111 2929 2928 2930 +2826 111 2932 2931 2933 +2827 111 2935 2934 2936 +2828 111 2938 2937 2939 +2829 111 2941 2940 2942 +2830 111 2944 2943 2945 +2831 111 2947 2946 2948 +2832 111 2950 2949 2951 +2833 111 2953 2952 2954 +2834 111 2956 2955 2957 +2835 111 2959 2958 2960 +2836 111 2962 2961 2963 +2837 111 2965 2964 2966 +2838 111 2968 2967 2969 +2839 111 2971 2970 2972 +2840 111 2974 2973 2975 +2841 111 2977 2976 2978 +2842 111 2980 2979 2981 +2843 111 2983 2982 2984 +2844 111 2986 2985 2987 +2845 111 2989 2988 2990 +2846 111 2992 2991 2993 +2847 111 2995 2994 2996 +2848 111 2998 2997 2999 +2849 111 3001 3000 3002 +2850 111 3004 3003 3005 +2851 111 3007 3006 3008 +2852 111 3010 3009 3011 +2853 111 3013 3012 3014 +2854 111 3016 3015 3017 +2855 111 3019 3018 3020 +2856 111 3022 3021 3023 +2857 111 3025 3024 3026 +2858 111 3028 3027 3029 +2859 111 3031 3030 3032 +2860 111 3034 3033 3035 +2861 111 3037 3036 3038 +2862 111 3040 3039 3041 +2863 111 3043 3042 3044 +2864 111 3046 3045 3047 +2865 111 3049 3048 3050 +2866 111 3052 3051 3053 +2867 111 3055 3054 3056 +2868 111 3058 3057 3059 +2869 111 3061 3060 3062 +2870 111 3064 3063 3065 +2871 111 3067 3066 3068 +2872 111 3070 3069 3071 +2873 111 3073 3072 3074 +2874 111 3076 3075 3077 +2875 111 3079 3078 3080 +2876 111 3082 3081 3083 +2877 111 3085 3084 3086 +2878 111 3088 3087 3089 +2879 111 3091 3090 3092 +2880 111 3094 3093 3095 +2881 111 3097 3096 3098 +2882 111 3100 3099 3101 +2883 111 3103 3102 3104 +2884 111 3106 3105 3107 +2885 111 3109 3108 3110 +2886 111 3112 3111 3113 +2887 111 3115 3114 3116 +2888 111 3118 3117 3119 +2889 111 3121 3120 3122 +2890 111 3124 3123 3125 +2891 111 3127 3126 3128 +2892 111 3130 3129 3131 +2893 111 3133 3132 3134 +2894 111 3136 3135 3137 +2895 111 3139 3138 3140 +2896 111 3142 3141 3143 +2897 111 3145 3144 3146 +2898 111 3148 3147 3149 +2899 111 3151 3150 3152 +2900 111 3154 3153 3155 +2901 111 3157 3156 3158 +2902 111 3160 3159 3161 +2903 111 3163 3162 3164 +2904 111 3166 3165 3167 +2905 111 3169 3168 3170 +2906 111 3172 3171 3173 +2907 111 3175 3174 3176 +2908 111 3178 3177 3179 +2909 111 3181 3180 3182 +2910 111 3184 3183 3185 +2911 111 3187 3186 3188 +2912 111 3190 3189 3191 +2913 111 3193 3192 3194 +2914 111 3196 3195 3197 +2915 111 3199 3198 3200 +2916 111 3202 3201 3203 +2917 111 3205 3204 3206 +2918 111 3208 3207 3209 +2919 111 3211 3210 3212 +2920 111 3214 3213 3215 +2921 111 3217 3216 3218 +2922 111 3220 3219 3221 +2923 111 3223 3222 3224 +2924 111 3226 3225 3227 +2925 111 3229 3228 3230 +2926 111 3232 3231 3233 +2927 111 3235 3234 3236 +2928 111 3238 3237 3239 +2929 111 3241 3240 3242 +2930 111 3244 3243 3245 +2931 111 3247 3246 3248 +2932 111 3250 3249 3251 +2933 111 3253 3252 3254 +2934 111 3256 3255 3257 +2935 111 3259 3258 3260 +2936 111 3262 3261 3263 +2937 111 3265 3264 3266 +2938 111 3268 3267 3269 +2939 111 3271 3270 3272 +2940 111 3274 3273 3275 +2941 111 3277 3276 3278 +2942 111 3280 3279 3281 +2943 111 3283 3282 3284 +2944 111 3286 3285 3287 +2945 111 3289 3288 3290 +2946 111 3292 3291 3293 +2947 111 3295 3294 3296 +2948 111 3298 3297 3299 +2949 111 3301 3300 3302 +2950 111 3304 3303 3305 +2951 111 3307 3306 3308 +2952 111 3310 3309 3311 +2953 111 3313 3312 3314 +2954 111 3316 3315 3317 +2955 111 3319 3318 3320 +2956 111 3322 3321 3323 +2957 111 3325 3324 3326 +2958 111 3328 3327 3329 +2959 111 3331 3330 3332 +2960 111 3334 3333 3335 +2961 111 3337 3336 3338 +2962 111 3340 3339 3341 +2963 111 3343 3342 3344 +2964 111 3346 3345 3347 +2965 111 3349 3348 3350 +2966 111 3352 3351 3353 +2967 111 3355 3354 3356 +2968 111 3358 3357 3359 +2969 111 3361 3360 3362 +2970 111 3364 3363 3365 +2971 111 3367 3366 3368 +2972 111 3370 3369 3371 +2973 111 3373 3372 3374 +2974 111 3376 3375 3377 +2975 111 3379 3378 3380 +2976 111 3382 3381 3383 +2977 111 3385 3384 3386 +2978 111 3388 3387 3389 +2979 111 3391 3390 3392 +2980 111 3394 3393 3395 +2981 111 3397 3396 3398 +2982 111 3400 3399 3401 +2983 111 3403 3402 3404 +2984 111 3406 3405 3407 +2985 111 3409 3408 3410 +2986 111 3412 3411 3413 +2987 111 3415 3414 3416 +2988 111 3418 3417 3419 +2989 111 3421 3420 3422 +2990 111 3424 3423 3425 +2991 111 3427 3426 3428 +2992 111 3430 3429 3431 +2993 111 3433 3432 3434 +2994 111 3436 3435 3437 +2995 111 3439 3438 3440 +2996 111 3442 3441 3443 +2997 111 3445 3444 3446 +2998 111 3448 3447 3449 +2999 111 3451 3450 3452 +3000 111 3454 3453 3455 +3001 111 3457 3456 3458 +3002 111 3460 3459 3461 +3003 111 3463 3462 3464 +3004 111 3466 3465 3467 +3005 111 3469 3468 3470 +3006 111 3472 3471 3473 +3007 111 3475 3474 3476 +3008 111 3478 3477 3479 +3009 111 3481 3480 3482 +3010 111 3484 3483 3485 +3011 111 3487 3486 3488 +3012 111 3490 3489 3491 +3013 111 3493 3492 3494 +3014 111 3496 3495 3497 +3015 111 3499 3498 3500 +3016 111 3502 3501 3503 +3017 111 3505 3504 3506 +3018 111 3508 3507 3509 +3019 111 3511 3510 3512 +3020 111 3514 3513 3515 +3021 111 3517 3516 3518 +3022 111 3520 3519 3521 +3023 111 3523 3522 3524 +3024 111 3526 3525 3527 +3025 111 3529 3528 3530 +3026 111 3532 3531 3533 +3027 111 3535 3534 3536 +3028 111 3538 3537 3539 +3029 111 3541 3540 3542 +3030 111 3544 3543 3545 +3031 111 3547 3546 3548 +3032 111 3550 3549 3551 +3033 111 3553 3552 3554 +3034 111 3556 3555 3557 +3035 111 3559 3558 3560 +3036 111 3562 3561 3563 +3037 111 3565 3564 3566 +3038 111 3568 3567 3569 +3039 111 3571 3570 3572 +3040 111 3574 3573 3575 +3041 111 3577 3576 3578 +3042 111 3580 3579 3581 +3043 111 3583 3582 3584 +3044 111 3586 3585 3587 +3045 111 3589 3588 3590 +3046 111 3592 3591 3593 +3047 111 3595 3594 3596 +3048 111 3598 3597 3599 +3049 111 3601 3600 3602 +3050 111 3604 3603 3605 +3051 111 3607 3606 3608 +3052 111 3610 3609 3611 +3053 111 3613 3612 3614 +3054 111 3616 3615 3617 +3055 111 3619 3618 3620 +3056 111 3622 3621 3623 +3057 111 3625 3624 3626 +3058 111 3628 3627 3629 +3059 111 3631 3630 3632 +3060 111 3634 3633 3635 +3061 111 3637 3636 3638 +3062 111 3640 3639 3641 +3063 111 3643 3642 3644 +3064 111 3646 3645 3647 +3065 111 3649 3648 3650 +3066 111 3652 3651 3653 +3067 111 3655 3654 3656 +3068 111 3658 3657 3659 +3069 111 3661 3660 3662 +3070 111 3664 3663 3665 +3071 111 3667 3666 3668 +3072 111 3670 3669 3671 +3073 111 3673 3672 3674 +3074 111 3676 3675 3677 +3075 111 3679 3678 3680 +3076 111 3682 3681 3683 +3077 111 3685 3684 3686 +3078 111 3688 3687 3689 +3079 111 3691 3690 3692 +3080 111 3694 3693 3695 +3081 111 3697 3696 3698 +3082 111 3700 3699 3701 +3083 111 3703 3702 3704 +3084 111 3706 3705 3707 +3085 111 3709 3708 3710 +3086 111 3712 3711 3713 +3087 111 3715 3714 3716 +3088 111 3718 3717 3719 +3089 111 3721 3720 3722 +3090 111 3724 3723 3725 +3091 111 3727 3726 3728 +3092 111 3730 3729 3731 +3093 111 3733 3732 3734 +3094 111 3736 3735 3737 +3095 111 3739 3738 3740 +3096 111 3742 3741 3743 +3097 111 3745 3744 3746 +3098 111 3748 3747 3749 +3099 111 3751 3750 3752 +3100 111 3754 3753 3755 +3101 111 3757 3756 3758 +3102 111 3760 3759 3761 +3103 111 3763 3762 3764 +3104 111 3766 3765 3767 +3105 111 3769 3768 3770 +3106 111 3772 3771 3773 +3107 111 3775 3774 3776 +3108 111 3778 3777 3779 +3109 111 3781 3780 3782 +3110 111 3784 3783 3785 +3111 111 3787 3786 3788 +3112 111 3790 3789 3791 +3113 111 3793 3792 3794 +3114 111 3796 3795 3797 +3115 111 3799 3798 3800 +3116 111 3802 3801 3803 +3117 111 3805 3804 3806 +3118 111 3808 3807 3809 +3119 111 3811 3810 3812 +3120 111 3814 3813 3815 +3121 111 3817 3816 3818 +3122 111 3820 3819 3821 +3123 111 3823 3822 3824 +3124 111 3826 3825 3827 +3125 111 3829 3828 3830 +3126 111 3832 3831 3833 +3127 111 3835 3834 3836 +3128 111 3838 3837 3839 +3129 111 3841 3840 3842 +3130 111 3844 3843 3845 +3131 111 3847 3846 3848 +3132 111 3850 3849 3851 +3133 111 3853 3852 3854 +3134 111 3856 3855 3857 +3135 111 3859 3858 3860 +3136 111 3862 3861 3863 +3137 111 3865 3864 3866 +3138 111 3868 3867 3869 +3139 111 3871 3870 3872 +3140 111 3874 3873 3875 +3141 111 3877 3876 3878 +3142 111 3880 3879 3881 +3143 111 3883 3882 3884 +3144 111 3886 3885 3887 +3145 111 3889 3888 3890 +3146 111 3892 3891 3893 +3147 111 3895 3894 3896 +3148 111 3898 3897 3899 +3149 111 3901 3900 3902 +3150 111 3904 3903 3905 +3151 111 3907 3906 3908 +3152 111 3910 3909 3911 +3153 111 3913 3912 3914 +3154 111 3916 3915 3917 +3155 111 3919 3918 3920 +3156 111 3922 3921 3923 +3157 111 3925 3924 3926 +3158 111 3928 3927 3929 +3159 111 3931 3930 3932 +3160 111 3934 3933 3935 +3161 111 3937 3936 3938 +3162 111 3940 3939 3941 +3163 111 3943 3942 3944 +3164 111 3946 3945 3947 +3165 111 3949 3948 3950 +3166 111 3952 3951 3953 +3167 111 3955 3954 3956 +3168 111 3958 3957 3959 +3169 111 3961 3960 3962 +3170 111 3964 3963 3965 +3171 111 3967 3966 3968 +3172 111 3970 3969 3971 +3173 111 3973 3972 3974 +3174 111 3976 3975 3977 +3175 111 3979 3978 3980 +3176 111 3982 3981 3983 +3177 111 3985 3984 3986 +3178 111 3988 3987 3989 +3179 111 3991 3990 3992 +3180 111 3994 3993 3995 +3181 111 3997 3996 3998 +3182 111 4000 3999 4001 +3183 111 4003 4002 4004 +3184 111 4006 4005 4007 +3185 111 4009 4008 4010 +3186 111 4012 4011 4013 +3187 111 4015 4014 4016 +3188 111 4018 4017 4019 +3189 111 4021 4020 4022 +3190 111 4024 4023 4025 +3191 111 4027 4026 4028 +3192 111 4030 4029 4031 +3193 111 4033 4032 4034 +3194 111 4036 4035 4037 +3195 111 4039 4038 4040 +3196 111 4042 4041 4043 +3197 111 4045 4044 4046 +3198 111 4048 4047 4049 +3199 111 4051 4050 4052 +3200 111 4054 4053 4055 +3201 111 4057 4056 4058 +3202 111 4060 4059 4061 +3203 111 4063 4062 4064 +3204 111 4066 4065 4067 +3205 111 4069 4068 4070 +3206 111 4072 4071 4073 +3207 111 4075 4074 4076 +3208 111 4078 4077 4079 +3209 111 4081 4080 4082 +3210 111 4084 4083 4085 +3211 111 4087 4086 4088 +3212 111 4090 4089 4091 +3213 111 4093 4092 4094 +3214 111 4096 4095 4097 +3215 111 4099 4098 4100 +3216 111 4102 4101 4103 +3217 111 4105 4104 4106 +3218 111 4108 4107 4109 +3219 111 4111 4110 4112 +3220 111 4114 4113 4115 +3221 111 4117 4116 4118 +3222 111 4120 4119 4121 +3223 111 4123 4122 4124 +3224 111 4126 4125 4127 +3225 111 4129 4128 4130 +3226 111 4132 4131 4133 +3227 111 4135 4134 4136 +3228 111 4138 4137 4139 +3229 111 4141 4140 4142 +3230 111 4144 4143 4145 +3231 111 4147 4146 4148 +3232 111 4150 4149 4151 +3233 111 4153 4152 4154 +3234 111 4156 4155 4157 +3235 111 4159 4158 4160 +3236 111 4162 4161 4163 +3237 111 4165 4164 4166 +3238 111 4168 4167 4169 +3239 111 4171 4170 4172 +3240 111 4174 4173 4175 +3241 111 4177 4176 4178 +3242 111 4180 4179 4181 +3243 111 4183 4182 4184 +3244 111 4186 4185 4187 +3245 111 4189 4188 4190 +3246 111 4192 4191 4193 +3247 111 4195 4194 4196 +3248 111 4198 4197 4199 +3249 111 4201 4200 4202 +3250 111 4204 4203 4205 +3251 111 4207 4206 4208 +3252 111 4210 4209 4211 +3253 111 4213 4212 4214 +3254 111 4216 4215 4217 +3255 111 4219 4218 4220 +3256 111 4222 4221 4223 +3257 111 4225 4224 4226 +3258 111 4228 4227 4229 +3259 111 4231 4230 4232 +3260 111 4234 4233 4235 +3261 111 4237 4236 4238 +3262 111 4240 4239 4241 +3263 111 4243 4242 4244 +3264 111 4246 4245 4247 +3265 111 4249 4248 4250 +3266 111 4252 4251 4253 +3267 111 4255 4254 4256 +3268 111 4258 4257 4259 +3269 111 4261 4260 4262 +3270 111 4264 4263 4265 +3271 111 4267 4266 4268 +3272 111 4270 4269 4271 +3273 111 4273 4272 4274 +3274 111 4276 4275 4277 +3275 111 4279 4278 4280 +3276 111 4282 4281 4283 +3277 111 4285 4284 4286 +3278 111 4288 4287 4289 +3279 111 4291 4290 4292 +3280 111 4294 4293 4295 +3281 111 4297 4296 4298 +3282 111 4300 4299 4301 +3283 111 4303 4302 4304 +3284 111 4306 4305 4307 +3285 111 4309 4308 4310 +3286 111 4312 4311 4313 +3287 111 4315 4314 4316 +3288 111 4318 4317 4319 +3289 111 4321 4320 4322 +3290 111 4324 4323 4325 +3291 111 4327 4326 4328 +3292 111 4330 4329 4331 +3293 111 4333 4332 4334 +3294 111 4336 4335 4337 +3295 111 4339 4338 4340 +3296 111 4342 4341 4343 +3297 111 4345 4344 4346 +3298 111 4348 4347 4349 +3299 111 4351 4350 4352 +3300 111 4354 4353 4355 +3301 111 4357 4356 4358 +3302 111 4360 4359 4361 +3303 111 4363 4362 4364 +3304 111 4366 4365 4367 +3305 111 4369 4368 4370 +3306 111 4372 4371 4373 +3307 111 4375 4374 4376 +3308 111 4378 4377 4379 +3309 111 4381 4380 4382 +3310 111 4384 4383 4385 +3311 111 4387 4386 4388 +3312 111 4390 4389 4391 +3313 111 4393 4392 4394 +3314 111 4396 4395 4397 +3315 111 4399 4398 4400 +3316 111 4402 4401 4403 +3317 111 4405 4404 4406 +3318 111 4408 4407 4409 +3319 111 4411 4410 4412 +3320 111 4414 4413 4415 +3321 111 4417 4416 4418 +3322 111 4420 4419 4421 +3323 111 4423 4422 4424 +3324 111 4426 4425 4427 +3325 111 4429 4428 4430 +3326 111 4432 4431 4433 +3327 111 4435 4434 4436 +3328 111 4438 4437 4439 +3329 111 4441 4440 4442 +3330 111 4444 4443 4445 +3331 111 4447 4446 4448 +3332 111 4450 4449 4451 +3333 111 4453 4452 4454 +3334 111 4456 4455 4457 +3335 111 4459 4458 4460 +3336 111 4462 4461 4463 +3337 111 4465 4464 4466 +3338 111 4468 4467 4469 +3339 111 4471 4470 4472 +3340 111 4474 4473 4475 +3341 111 4477 4476 4478 +3342 111 4480 4479 4481 +3343 111 4483 4482 4484 +3344 111 4486 4485 4487 +3345 111 4489 4488 4490 +3346 111 4492 4491 4493 +3347 111 4495 4494 4496 +3348 111 4498 4497 4499 +3349 111 4501 4500 4502 +3350 111 4504 4503 4505 +3351 111 4507 4506 4508 +3352 111 4510 4509 4511 +3353 111 4513 4512 4514 +3354 111 4516 4515 4517 +3355 111 4519 4518 4520 +3356 111 4522 4521 4523 +3357 111 4525 4524 4526 +3358 111 4528 4527 4529 +3359 111 4531 4530 4532 +3360 111 4534 4533 4535 +3361 111 4537 4536 4538 +3362 111 4540 4539 4541 +3363 111 4543 4542 4544 +3364 111 4546 4545 4547 +3365 111 4549 4548 4550 +3366 111 4552 4551 4553 +3367 111 4555 4554 4556 +3368 111 4558 4557 4559 +3369 111 4561 4560 4562 +3370 111 4564 4563 4565 +3371 111 4567 4566 4568 +3372 111 4570 4569 4571 +3373 111 4573 4572 4574 +3374 111 4576 4575 4577 +3375 111 4579 4578 4580 +3376 111 4582 4581 4583 +3377 111 4585 4584 4586 +3378 111 4588 4587 4589 +3379 111 4591 4590 4592 +3380 111 4594 4593 4595 +3381 111 4597 4596 4598 +3382 111 4600 4599 4601 +3383 111 4603 4602 4604 +3384 111 4606 4605 4607 +3385 111 4609 4608 4610 +3386 111 4612 4611 4613 +3387 111 4615 4614 4616 +3388 111 4618 4617 4619 +3389 111 4621 4620 4622 +3390 111 4624 4623 4625 +3391 111 4627 4626 4628 +3392 111 4630 4629 4631 +3393 111 4633 4632 4634 +3394 111 4636 4635 4637 +3395 111 4639 4638 4640 +3396 111 4642 4641 4643 +3397 111 4645 4644 4646 +3398 111 4648 4647 4649 +3399 111 4651 4650 4652 +3400 111 4654 4653 4655 +3401 111 4657 4656 4658 +3402 111 4660 4659 4661 +3403 111 4663 4662 4664 +3404 111 4666 4665 4667 +3405 111 4669 4668 4670 +3406 111 4672 4671 4673 +3407 111 4675 4674 4676 +3408 111 4678 4677 4679 +3409 111 4681 4680 4682 +3410 111 4684 4683 4685 +3411 111 4687 4686 4688 +3412 111 4690 4689 4691 +3413 111 4693 4692 4694 +3414 111 4696 4695 4697 +3415 111 4699 4698 4700 +3416 111 4702 4701 4703 +3417 111 4705 4704 4706 +3418 111 4708 4707 4709 +3419 111 4711 4710 4712 +3420 111 4714 4713 4715 +3421 111 4717 4716 4718 +3422 111 4720 4719 4721 +3423 111 4723 4722 4724 +3424 111 4726 4725 4727 +3425 111 4729 4728 4730 +3426 111 4732 4731 4733 +3427 111 4735 4734 4736 +3428 111 4738 4737 4739 +3429 111 4741 4740 4742 +3430 111 4744 4743 4745 +3431 111 4747 4746 4748 +3432 111 4750 4749 4751 +3433 111 4753 4752 4754 +3434 111 4756 4755 4757 +3435 111 4759 4758 4760 +3436 111 4762 4761 4763 +3437 111 4765 4764 4766 +3438 111 4768 4767 4769 +3439 111 4771 4770 4772 +3440 111 4774 4773 4775 +3441 111 4777 4776 4778 +3442 111 4780 4779 4781 +3443 111 4783 4782 4784 +3444 111 4786 4785 4787 +3445 111 4789 4788 4790 +3446 111 4792 4791 4793 +3447 111 4795 4794 4796 +3448 111 4798 4797 4799 +3449 111 4801 4800 4802 +3450 111 4804 4803 4805 +3451 111 4807 4806 4808 +3452 111 4810 4809 4811 +3453 111 4813 4812 4814 +3454 111 4816 4815 4817 +3455 111 4819 4818 4820 +3456 111 4822 4821 4823 +3457 111 4825 4824 4826 +3458 111 4828 4827 4829 +3459 111 4831 4830 4832 +3460 111 4834 4833 4835 +3461 111 4837 4836 4838 +3462 111 4840 4839 4841 +3463 111 4843 4842 4844 +3464 111 4846 4845 4847 +3465 111 4849 4848 4850 +3466 111 4852 4851 4853 +3467 111 4855 4854 4856 +3468 111 4858 4857 4859 +3469 111 4861 4860 4862 +3470 111 4864 4863 4865 +3471 111 4867 4866 4868 +3472 111 4870 4869 4871 +3473 111 4873 4872 4874 +3474 111 4876 4875 4877 +3475 111 4879 4878 4880 +3476 111 4882 4881 4883 +3477 111 4885 4884 4886 +3478 111 4888 4887 4889 +3479 111 4891 4890 4892 +3480 111 4894 4893 4895 +3481 111 4897 4896 4898 +3482 111 4900 4899 4901 +3483 111 4903 4902 4904 +3484 111 4906 4905 4907 +3485 111 4909 4908 4910 +3486 111 4912 4911 4913 +3487 111 4915 4914 4916 +3488 111 4918 4917 4919 +3489 111 4921 4920 4922 +3490 111 4924 4923 4925 +3491 111 4927 4926 4928 +3492 111 4930 4929 4931 +3493 111 4933 4932 4934 +3494 111 4936 4935 4937 +3495 111 4939 4938 4940 +3496 111 4942 4941 4943 +3497 111 4945 4944 4946 +3498 111 4948 4947 4949 +3499 111 4951 4950 4952 +3500 111 4954 4953 4955 +3501 111 4957 4956 4958 +3502 111 4960 4959 4961 +3503 111 4963 4962 4964 +3504 111 4966 4965 4967 +3505 111 4969 4968 4970 +3506 111 4972 4971 4973 +3507 111 4975 4974 4976 +3508 111 4978 4977 4979 +3509 111 4981 4980 4982 +3510 111 4984 4983 4985 +3511 111 4987 4986 4988 +3512 111 4990 4989 4991 +3513 111 4993 4992 4994 +3514 111 4996 4995 4997 +3515 111 4999 4998 5000 +3516 111 5002 5001 5003 +3517 111 5005 5004 5006 +3518 111 5008 5007 5009 +3519 111 5011 5010 5012 +3520 111 5014 5013 5015 +3521 111 5017 5016 5018 +3522 111 5020 5019 5021 +3523 111 5023 5022 5024 +3524 111 5026 5025 5027 +3525 111 5029 5028 5030 +3526 111 5032 5031 5033 +3527 111 5035 5034 5036 +3528 111 5038 5037 5039 +3529 111 5041 5040 5042 +3530 111 5044 5043 5045 +3531 111 5047 5046 5048 +3532 111 5050 5049 5051 +3533 111 5053 5052 5054 +3534 111 5056 5055 5057 +3535 111 5059 5058 5060 +3536 111 5062 5061 5063 +3537 111 5065 5064 5066 +3538 111 5068 5067 5069 +3539 111 5071 5070 5072 +3540 111 5074 5073 5075 +3541 111 5077 5076 5078 +3542 111 5080 5079 5081 +3543 111 5083 5082 5084 +3544 111 5086 5085 5087 +3545 111 5089 5088 5090 +3546 111 5092 5091 5093 +3547 111 5095 5094 5096 +3548 111 5098 5097 5099 +3549 111 5101 5100 5102 +3550 111 5104 5103 5105 +3551 111 5107 5106 5108 +3552 111 5110 5109 5111 +3553 111 5113 5112 5114 +3554 111 5116 5115 5117 +3555 111 5119 5118 5120 +3556 111 5122 5121 5123 +3557 111 5125 5124 5126 +3558 111 5128 5127 5129 +3559 111 5131 5130 5132 +3560 111 5134 5133 5135 +3561 111 5137 5136 5138 +3562 111 5140 5139 5141 +3563 111 5143 5142 5144 +3564 111 5146 5145 5147 +3565 111 5149 5148 5150 +3566 111 5152 5151 5153 +3567 111 5155 5154 5156 +3568 111 5158 5157 5159 +3569 111 5161 5160 5162 +3570 111 5164 5163 5165 +3571 111 5167 5166 5168 +3572 111 5170 5169 5171 +3573 111 5173 5172 5174 +3574 111 5176 5175 5177 +3575 111 5179 5178 5180 +3576 111 5182 5181 5183 +3577 111 5185 5184 5186 +3578 111 5188 5187 5189 +3579 111 5191 5190 5192 +3580 111 5194 5193 5195 +3581 111 5197 5196 5198 +3582 111 5200 5199 5201 +3583 111 5203 5202 5204 +3584 111 5206 5205 5207 +3585 111 5209 5208 5210 +3586 111 5212 5211 5213 +3587 111 5215 5214 5216 +3588 111 5218 5217 5219 +3589 111 5221 5220 5222 +3590 111 5224 5223 5225 +3591 111 5227 5226 5228 +3592 111 5230 5229 5231 +3593 111 5233 5232 5234 +3594 111 5236 5235 5237 +3595 111 5239 5238 5240 +3596 111 5242 5241 5243 +3597 111 5245 5244 5246 +3598 111 5248 5247 5249 +3599 111 5251 5250 5252 +3600 111 5254 5253 5255 +3601 111 5257 5256 5258 +3602 111 5260 5259 5261 +3603 111 5263 5262 5264 +3604 111 5266 5265 5267 +3605 111 5269 5268 5270 +3606 111 5272 5271 5273 +3607 111 5275 5274 5276 +3608 111 5278 5277 5279 +3609 111 5281 5280 5282 +3610 111 5284 5283 5285 +3611 111 5287 5286 5288 +3612 111 5290 5289 5291 +3613 111 5293 5292 5294 +3614 111 5296 5295 5297 +3615 111 5299 5298 5300 +3616 111 5302 5301 5303 +3617 111 5305 5304 5306 +3618 111 5308 5307 5309 +3619 111 5311 5310 5312 +3620 111 5314 5313 5315 +3621 111 5317 5316 5318 +3622 111 5320 5319 5321 +3623 111 5323 5322 5324 +3624 111 5326 5325 5327 +3625 111 5329 5328 5330 +3626 111 5332 5331 5333 +3627 111 5335 5334 5336 +3628 111 5338 5337 5339 +3629 111 5341 5340 5342 +3630 111 5344 5343 5345 +3631 111 5347 5346 5348 +3632 111 5350 5349 5351 +3633 111 5353 5352 5354 +3634 111 5356 5355 5357 +3635 111 5359 5358 5360 +3636 111 5362 5361 5363 +3637 111 5365 5364 5366 +3638 111 5368 5367 5369 +3639 111 5371 5370 5372 +3640 111 5374 5373 5375 +3641 111 5377 5376 5378 +3642 111 5380 5379 5381 +3643 111 5383 5382 5384 +3644 111 5386 5385 5387 +3645 111 5389 5388 5390 +3646 111 5392 5391 5393 +3647 111 5395 5394 5396 +3648 111 5398 5397 5399 +3649 111 5401 5400 5402 +3650 111 5404 5403 5405 +3651 111 5407 5406 5408 +3652 111 5410 5409 5411 +3653 111 5413 5412 5414 +3654 111 5416 5415 5417 +3655 111 5419 5418 5420 +3656 111 5422 5421 5423 +3657 111 5425 5424 5426 +3658 111 5428 5427 5429 +3659 111 5431 5430 5432 +3660 111 5434 5433 5435 +3661 111 5437 5436 5438 +3662 111 5440 5439 5441 +3663 111 5443 5442 5444 +3664 111 5446 5445 5447 +3665 111 5449 5448 5450 +3666 111 5452 5451 5453 +3667 111 5455 5454 5456 +3668 111 5458 5457 5459 +3669 111 5461 5460 5462 +3670 111 5464 5463 5465 +3671 111 5467 5466 5468 +3672 111 5470 5469 5471 +3673 111 5473 5472 5474 +3674 111 5476 5475 5477 +3675 111 5479 5478 5480 +3676 111 5482 5481 5483 +3677 111 5485 5484 5486 +3678 111 5488 5487 5489 +3679 111 5491 5490 5492 +3680 111 5494 5493 5495 +3681 111 5497 5496 5498 +3682 111 5500 5499 5501 +3683 111 5503 5502 5504 +3684 111 5506 5505 5507 +3685 111 5509 5508 5510 +3686 111 5512 5511 5513 +3687 111 5515 5514 5516 +3688 111 5518 5517 5519 +3689 111 5521 5520 5522 +3690 111 5524 5523 5525 +3691 111 5527 5526 5528 +3692 111 5530 5529 5531 +3693 111 5533 5532 5534 +3694 111 5536 5535 5537 +3695 111 5539 5538 5540 +3696 111 5542 5541 5543 +3697 111 5545 5544 5546 +3698 111 5548 5547 5549 +3699 111 5551 5550 5552 +3700 111 5554 5553 5555 +3701 111 5557 5556 5558 +3702 111 5560 5559 5561 +3703 111 5563 5562 5564 +3704 111 5566 5565 5567 +3705 111 5569 5568 5570 +3706 111 5572 5571 5573 +3707 111 5575 5574 5576 +3708 111 5578 5577 5579 +3709 111 5581 5580 5582 +3710 111 5584 5583 5585 +3711 111 5587 5586 5588 +3712 111 5590 5589 5591 +3713 111 5593 5592 5594 +3714 111 5596 5595 5597 +3715 111 5599 5598 5600 +3716 111 5602 5601 5603 +3717 111 5605 5604 5606 +3718 111 5608 5607 5609 +3719 111 5611 5610 5612 +3720 111 5614 5613 5615 +3721 111 5617 5616 5618 +3722 111 5620 5619 5621 +3723 111 5623 5622 5624 +3724 111 5626 5625 5627 +3725 111 5629 5628 5630 +3726 111 5632 5631 5633 +3727 111 5635 5634 5636 +3728 111 5638 5637 5639 +3729 111 5641 5640 5642 +3730 111 5644 5643 5645 +3731 111 5647 5646 5648 +3732 111 5650 5649 5651 +3733 111 5653 5652 5654 +3734 111 5656 5655 5657 +3735 111 5659 5658 5660 +3736 111 5662 5661 5663 +3737 111 5665 5664 5666 +3738 111 5668 5667 5669 +3739 111 5671 5670 5672 +3740 111 5674 5673 5675 +3741 111 5677 5676 5678 +3742 111 5680 5679 5681 +3743 111 5683 5682 5684 +3744 111 5686 5685 5687 +3745 111 5689 5688 5690 +3746 111 5692 5691 5693 +3747 111 5695 5694 5696 +3748 111 5698 5697 5699 +3749 111 5701 5700 5702 +3750 111 5704 5703 5705 +3751 111 5707 5706 5708 +3752 111 5710 5709 5711 +3753 111 5713 5712 5714 +3754 111 5716 5715 5717 +3755 111 5719 5718 5720 +3756 111 5722 5721 5723 +3757 111 5725 5724 5726 +3758 111 5728 5727 5729 +3759 111 5731 5730 5732 +3760 111 5734 5733 5735 +3761 111 5737 5736 5738 +3762 111 5740 5739 5741 +3763 111 5743 5742 5744 +3764 111 5746 5745 5747 +3765 111 5749 5748 5750 +3766 111 5752 5751 5753 +3767 111 5755 5754 5756 +3768 111 5758 5757 5759 +3769 111 5761 5760 5762 +3770 111 5764 5763 5765 +3771 111 5767 5766 5768 +3772 111 5770 5769 5771 +3773 111 5773 5772 5774 +3774 111 5776 5775 5777 +3775 111 5779 5778 5780 +3776 111 5782 5781 5783 +3777 111 5785 5784 5786 +3778 111 5788 5787 5789 +3779 111 5791 5790 5792 +3780 111 5794 5793 5795 +3781 111 5797 5796 5798 +3782 111 5800 5799 5801 +3783 111 5803 5802 5804 +3784 111 5806 5805 5807 +3785 111 5809 5808 5810 +3786 111 5812 5811 5813 +3787 111 5815 5814 5816 +3788 111 5818 5817 5819 +3789 111 5821 5820 5822 +3790 111 5824 5823 5825 +3791 111 5827 5826 5828 +3792 111 5830 5829 5831 +3793 111 5833 5832 5834 +3794 111 5836 5835 5837 +3795 111 5839 5838 5840 +3796 111 5842 5841 5843 +3797 111 5845 5844 5846 +3798 111 5848 5847 5849 +3799 111 5851 5850 5852 +3800 111 5854 5853 5855 +3801 111 5857 5856 5858 +3802 111 5860 5859 5861 +3803 111 5863 5862 5864 +3804 111 5866 5865 5867 +3805 111 5869 5868 5870 +3806 111 5872 5871 5873 +3807 111 5875 5874 5876 +3808 111 5878 5877 5879 +3809 111 5881 5880 5882 +3810 111 5884 5883 5885 +3811 111 5887 5886 5888 +3812 111 5890 5889 5891 +3813 111 5893 5892 5894 +3814 111 5896 5895 5897 +3815 111 5899 5898 5900 +3816 111 5902 5901 5903 +3817 111 5905 5904 5906 +3818 111 5908 5907 5909 +3819 111 5911 5910 5912 +3820 111 5914 5913 5915 +3821 111 5917 5916 5918 +3822 111 5920 5919 5921 +3823 111 5923 5922 5924 +3824 111 5926 5925 5927 +3825 111 5929 5928 5930 +3826 111 5932 5931 5933 +3827 111 5935 5934 5936 +3828 111 5938 5937 5939 +3829 111 5941 5940 5942 +3830 111 5944 5943 5945 +3831 111 5947 5946 5948 +3832 111 5950 5949 5951 +3833 111 5953 5952 5954 +3834 111 5956 5955 5957 +3835 111 5959 5958 5960 +3836 111 5962 5961 5963 +3837 111 5965 5964 5966 +3838 111 5968 5967 5969 +3839 111 5971 5970 5972 +3840 111 5974 5973 5975 +3841 111 5977 5976 5978 +3842 111 5980 5979 5981 +3843 111 5983 5982 5984 +3844 111 5986 5985 5987 +3845 111 5989 5988 5990 +3846 111 5992 5991 5993 +3847 111 5995 5994 5996 +3848 111 5998 5997 5999 +3849 111 6001 6000 6002 +3850 111 6004 6003 6005 +3851 111 6007 6006 6008 +3852 111 6010 6009 6011 +3853 111 6013 6012 6014 +3854 111 6016 6015 6017 +3855 111 6019 6018 6020 +3856 111 6022 6021 6023 +3857 111 6025 6024 6026 +3858 111 6028 6027 6029 +3859 111 6031 6030 6032 +3860 111 6034 6033 6035 +3861 111 6037 6036 6038 +3862 111 6040 6039 6041 +3863 111 6043 6042 6044 +3864 111 6046 6045 6047 +3865 111 6049 6048 6050 +3866 111 6052 6051 6053 +3867 111 6055 6054 6056 +3868 111 6058 6057 6059 +3869 111 6061 6060 6062 +3870 111 6064 6063 6065 +3871 111 6067 6066 6068 +3872 111 6070 6069 6071 +3873 111 6073 6072 6074 +3874 111 6076 6075 6077 +3875 111 6079 6078 6080 +3876 111 6082 6081 6083 +3877 111 6085 6084 6086 +3878 111 6088 6087 6089 +3879 111 6091 6090 6092 +3880 111 6094 6093 6095 +3881 111 6097 6096 6098 +3882 111 6100 6099 6101 +3883 111 6103 6102 6104 +3884 111 6106 6105 6107 +3885 111 6109 6108 6110 +3886 111 6112 6111 6113 +3887 111 6115 6114 6116 +3888 111 6118 6117 6119 +3889 111 6121 6120 6122 +3890 111 6124 6123 6125 +3891 111 6127 6126 6128 +3892 111 6130 6129 6131 +3893 111 6133 6132 6134 +3894 111 6136 6135 6137 +3895 111 6139 6138 6140 +3896 111 6142 6141 6143 +3897 111 6145 6144 6146 +3898 111 6148 6147 6149 +3899 111 6151 6150 6152 +3900 111 6154 6153 6155 +3901 111 6157 6156 6158 +3902 111 6160 6159 6161 +3903 111 6163 6162 6164 +3904 111 6166 6165 6167 +3905 111 6169 6168 6170 +3906 111 6172 6171 6173 +3907 111 6175 6174 6176 +3908 111 6178 6177 6179 +3909 111 6181 6180 6182 +3910 111 6184 6183 6185 +3911 111 6187 6186 6188 +3912 111 6190 6189 6191 +3913 111 6193 6192 6194 +3914 111 6196 6195 6197 +3915 111 6199 6198 6200 +3916 111 6202 6201 6203 +3917 111 6205 6204 6206 +3918 111 6208 6207 6209 +3919 111 6211 6210 6212 +3920 111 6214 6213 6215 +3921 111 6217 6216 6218 +3922 111 6220 6219 6221 +3923 111 6223 6222 6224 +3924 111 6226 6225 6227 +3925 111 6229 6228 6230 +3926 111 6232 6231 6233 +3927 111 6235 6234 6236 +3928 111 6238 6237 6239 +3929 111 6241 6240 6242 +3930 111 6244 6243 6245 +3931 111 6247 6246 6248 +3932 111 6250 6249 6251 +3933 111 6253 6252 6254 +3934 111 6256 6255 6257 +3935 111 6259 6258 6260 +3936 111 6262 6261 6263 +3937 111 6265 6264 6266 +3938 111 6268 6267 6269 +3939 111 6271 6270 6272 +3940 111 6274 6273 6275 +3941 111 6277 6276 6278 +3942 111 6280 6279 6281 +3943 111 6283 6282 6284 +3944 111 6286 6285 6287 +3945 111 6289 6288 6290 +3946 111 6292 6291 6293 +3947 111 6295 6294 6296 +3948 111 6298 6297 6299 +3949 111 6301 6300 6302 +3950 111 6304 6303 6305 +3951 111 6307 6306 6308 +3952 111 6310 6309 6311 +3953 111 6313 6312 6314 +3954 111 6316 6315 6317 +3955 111 6319 6318 6320 +3956 111 6322 6321 6323 +3957 111 6325 6324 6326 +3958 111 6328 6327 6329 +3959 111 6331 6330 6332 +3960 111 6334 6333 6335 +3961 111 6337 6336 6338 +3962 111 6340 6339 6341 +3963 111 6343 6342 6344 +3964 111 6346 6345 6347 +3965 111 6349 6348 6350 +3966 111 6352 6351 6353 +3967 111 6355 6354 6356 +3968 111 6358 6357 6359 +3969 111 6361 6360 6362 +3970 111 6364 6363 6365 +3971 111 6367 6366 6368 +3972 111 6370 6369 6371 +3973 111 6373 6372 6374 +3974 111 6376 6375 6377 +3975 111 6379 6378 6380 +3976 111 6382 6381 6383 +3977 111 6385 6384 6386 +3978 111 6388 6387 6389 +3979 111 6391 6390 6392 +3980 111 6394 6393 6395 +3981 111 6397 6396 6398 +3982 111 6400 6399 6401 +3983 111 6403 6402 6404 +3984 111 6406 6405 6407 +3985 111 6409 6408 6410 +3986 111 6412 6411 6413 +3987 111 6415 6414 6416 +3988 111 6418 6417 6419 +3989 111 6421 6420 6422 +3990 111 6424 6423 6425 +3991 111 6427 6426 6428 +3992 111 6430 6429 6431 +3993 111 6433 6432 6434 +3994 111 6436 6435 6437 +3995 111 6439 6438 6440 +3996 111 6442 6441 6443 +3997 111 6445 6444 6446 +3998 111 6448 6447 6449 +3999 111 6451 6450 6452 +4000 111 6454 6453 6455 +4001 111 6457 6456 6458 +4002 111 6460 6459 6461 +4003 111 6463 6462 6464 +4004 111 6466 6465 6467 +4005 111 6469 6468 6470 +4006 111 6472 6471 6473 +4007 111 6475 6474 6476 +4008 111 6478 6477 6479 +4009 111 6481 6480 6482 +4010 111 6484 6483 6485 +4011 111 6487 6486 6488 +4012 111 6490 6489 6491 +4013 111 6493 6492 6494 +4014 111 6496 6495 6497 +4015 111 6499 6498 6500 +4016 111 6502 6501 6503 +4017 111 6505 6504 6506 +4018 111 6508 6507 6509 +4019 111 6511 6510 6512 +4020 111 6514 6513 6515 +4021 111 6517 6516 6518 +4022 111 6520 6519 6521 +4023 111 6523 6522 6524 +4024 111 6526 6525 6527 +4025 111 6529 6528 6530 +4026 111 6532 6531 6533 +4027 111 6535 6534 6536 +4028 111 6538 6537 6539 +4029 111 6541 6540 6542 +4030 111 6544 6543 6545 +4031 111 6547 6546 6548 +4032 111 6550 6549 6551 +4033 111 6553 6552 6554 +4034 111 6556 6555 6557 +4035 111 6559 6558 6560 +4036 111 6562 6561 6563 +4037 111 6565 6564 6566 +4038 111 6568 6567 6569 +4039 111 6571 6570 6572 +4040 111 6574 6573 6575 +4041 111 6577 6576 6578 +4042 111 6580 6579 6581 +4043 111 6583 6582 6584 +4044 111 6586 6585 6587 +4045 111 6589 6588 6590 +4046 111 6592 6591 6593 +4047 111 6595 6594 6596 +4048 111 6598 6597 6599 +4049 111 6601 6600 6602 +4050 111 6604 6603 6605 +4051 111 6607 6606 6608 +4052 111 6610 6609 6611 +4053 111 6613 6612 6614 +4054 111 6616 6615 6617 +4055 111 6619 6618 6620 +4056 111 6622 6621 6623 +4057 111 6625 6624 6626 +4058 111 6628 6627 6629 +4059 111 6631 6630 6632 +4060 111 6634 6633 6635 +4061 111 6637 6636 6638 +4062 111 6640 6639 6641 +4063 111 6643 6642 6644 +4064 111 6646 6645 6647 +4065 111 6649 6648 6650 +4066 111 6652 6651 6653 +4067 111 6655 6654 6656 +4068 111 6658 6657 6659 +4069 111 6661 6660 6662 +4070 111 6664 6663 6665 +4071 111 6667 6666 6668 +4072 111 6670 6669 6671 +4073 111 6673 6672 6674 +4074 111 6676 6675 6677 +4075 111 6679 6678 6680 +4076 111 6682 6681 6683 +4077 111 6685 6684 6686 +4078 111 6688 6687 6689 +4079 111 6691 6690 6692 +4080 111 6694 6693 6695 +4081 111 6697 6696 6698 +4082 111 6700 6699 6701 +4083 111 6703 6702 6704 +4084 111 6706 6705 6707 +4085 111 6709 6708 6710 +4086 111 6712 6711 6713 +4087 111 6715 6714 6716 +4088 111 6718 6717 6719 +4089 111 6721 6720 6722 +4090 111 6724 6723 6725 +4091 111 6727 6726 6728 +4092 111 6730 6729 6731 +4093 111 6733 6732 6734 +4094 111 6736 6735 6737 +4095 111 6739 6738 6740 +4096 111 6742 6741 6743 +4097 111 6745 6744 6746 +4098 111 6748 6747 6749 +4099 111 6751 6750 6752 +4100 111 6754 6753 6755 +4101 111 6757 6756 6758 +4102 111 6760 6759 6761 +4103 111 6763 6762 6764 +4104 111 6766 6765 6767 +4105 111 6769 6768 6770 +4106 111 6772 6771 6773 +4107 111 6775 6774 6776 +4108 111 6778 6777 6779 +4109 111 6781 6780 6782 +4110 111 6784 6783 6785 +4111 111 6787 6786 6788 +4112 111 6790 6789 6791 +4113 111 6793 6792 6794 +4114 111 6796 6795 6797 +4115 111 6799 6798 6800 +4116 111 6802 6801 6803 +4117 111 6805 6804 6806 +4118 111 6808 6807 6809 +4119 111 6811 6810 6812 +4120 111 6814 6813 6815 +4121 111 6817 6816 6818 +4122 111 6820 6819 6821 +4123 111 6823 6822 6824 +4124 111 6826 6825 6827 +4125 111 6829 6828 6830 +4126 111 6832 6831 6833 +4127 111 6835 6834 6836 +4128 111 6838 6837 6839 +4129 111 6841 6840 6842 +4130 111 6844 6843 6845 +4131 111 6847 6846 6848 +4132 111 6850 6849 6851 +4133 111 6853 6852 6854 +4134 111 6856 6855 6857 +4135 111 6859 6858 6860 +4136 111 6862 6861 6863 +4137 111 6865 6864 6866 +4138 111 6868 6867 6869 +4139 111 6871 6870 6872 +4140 111 6874 6873 6875 +4141 111 6877 6876 6878 +4142 111 6880 6879 6881 +4143 111 6883 6882 6884 +4144 111 6886 6885 6887 +4145 111 6889 6888 6890 +4146 111 6892 6891 6893 +4147 111 6895 6894 6896 +4148 111 6898 6897 6899 +4149 111 6901 6900 6902 +4150 111 6904 6903 6905 +4151 111 6907 6906 6908 +4152 111 6910 6909 6911 +4153 111 6913 6912 6914 +4154 111 6916 6915 6917 +4155 111 6919 6918 6920 +4156 111 6922 6921 6923 +4157 111 6925 6924 6926 +4158 111 6928 6927 6929 +4159 111 6931 6930 6932 +4160 111 6934 6933 6935 +4161 111 6937 6936 6938 +4162 111 6940 6939 6941 +4163 111 6943 6942 6944 +4164 111 6946 6945 6947 +4165 111 6949 6948 6950 +4166 111 6952 6951 6953 +4167 111 6955 6954 6956 +4168 111 6958 6957 6959 +4169 111 6961 6960 6962 +4170 111 6964 6963 6965 +4171 111 6967 6966 6968 +4172 111 6970 6969 6971 +4173 111 6973 6972 6974 +4174 111 6976 6975 6977 +4175 111 6979 6978 6980 +4176 111 6982 6981 6983 +4177 111 6985 6984 6986 +4178 111 6988 6987 6989 +4179 111 6991 6990 6992 +4180 111 6994 6993 6995 +4181 111 6997 6996 6998 +4182 111 7000 6999 7001 +4183 111 7003 7002 7004 +4184 111 7006 7005 7007 +4185 111 7009 7008 7010 +4186 111 7012 7011 7013 +4187 111 7015 7014 7016 +4188 111 7018 7017 7019 +4189 111 7021 7020 7022 +4190 111 7024 7023 7025 +4191 111 7027 7026 7028 +4192 111 7030 7029 7031 +4193 111 7033 7032 7034 +4194 111 7036 7035 7037 +4195 111 7039 7038 7040 +4196 111 7042 7041 7043 +4197 111 7045 7044 7046 +4198 111 7048 7047 7049 +4199 111 7051 7050 7052 +4200 111 7054 7053 7055 +4201 111 7057 7056 7058 +4202 111 7060 7059 7061 +4203 111 7063 7062 7064 +4204 111 7066 7065 7067 +4205 111 7069 7068 7070 +4206 111 7072 7071 7073 +4207 111 7075 7074 7076 +4208 111 7078 7077 7079 +4209 111 7081 7080 7082 +4210 111 7084 7083 7085 +4211 111 7087 7086 7088 +4212 111 7090 7089 7091 +4213 111 7093 7092 7094 +4214 111 7096 7095 7097 +4215 111 7099 7098 7100 +4216 111 7102 7101 7103 +4217 111 7105 7104 7106 +4218 111 7108 7107 7109 +4219 111 7111 7110 7112 +4220 111 7114 7113 7115 +4221 111 7117 7116 7118 +4222 111 7120 7119 7121 +4223 111 7123 7122 7124 +4224 111 7126 7125 7127 +4225 111 7129 7128 7130 +4226 111 7132 7131 7133 +4227 111 7135 7134 7136 +4228 111 7138 7137 7139 +4229 111 7141 7140 7142 +4230 111 7144 7143 7145 +4231 111 7147 7146 7148 +4232 111 7150 7149 7151 +4233 111 7153 7152 7154 +4234 111 7156 7155 7157 +4235 111 7159 7158 7160 +4236 111 7162 7161 7163 +4237 111 7165 7164 7166 +4238 111 7168 7167 7169 +4239 111 7171 7170 7172 +4240 111 7174 7173 7175 +4241 111 7177 7176 7178 +4242 111 7180 7179 7181 +4243 111 7183 7182 7184 +4244 111 7186 7185 7187 +4245 111 7189 7188 7190 +4246 111 7192 7191 7193 +4247 111 7195 7194 7196 +4248 111 7198 7197 7199 +4249 111 7201 7200 7202 +4250 111 7204 7203 7205 +4251 111 7207 7206 7208 +4252 111 7210 7209 7211 +4253 111 7213 7212 7214 +4254 111 7216 7215 7217 +4255 111 7219 7218 7220 +4256 111 7222 7221 7223 +4257 111 7225 7224 7226 +4258 111 7228 7227 7229 +4259 111 7231 7230 7232 +4260 111 7234 7233 7235 +4261 111 7237 7236 7238 +4262 111 7240 7239 7241 +4263 111 7243 7242 7244 +4264 111 7246 7245 7247 +4265 111 7249 7248 7250 +4266 111 7252 7251 7253 +4267 111 7255 7254 7256 +4268 111 7258 7257 7259 +4269 111 7261 7260 7262 +4270 111 7264 7263 7265 +4271 111 7267 7266 7268 +4272 111 7270 7269 7271 +4273 111 7273 7272 7274 +4274 111 7276 7275 7277 +4275 111 7279 7278 7280 +4276 111 7282 7281 7283 +4277 111 7285 7284 7286 +4278 111 7288 7287 7289 +4279 111 7291 7290 7292 +4280 111 7294 7293 7295 +4281 111 7297 7296 7298 +4282 111 7300 7299 7301 +4283 111 7303 7302 7304 +4284 111 7306 7305 7307 +4285 111 7309 7308 7310 +4286 111 7312 7311 7313 +4287 111 7315 7314 7316 +4288 111 7318 7317 7319 +4289 111 7321 7320 7322 +4290 111 7324 7323 7325 +4291 111 7327 7326 7328 +4292 111 7330 7329 7331 +4293 111 7333 7332 7334 +4294 111 7336 7335 7337 +4295 111 7339 7338 7340 +4296 111 7342 7341 7343 +4297 111 7345 7344 7346 +4298 111 7348 7347 7349 +4299 111 7351 7350 7352 +4300 111 7354 7353 7355 +4301 111 7357 7356 7358 +4302 111 7360 7359 7361 +4303 111 7363 7362 7364 +4304 111 7366 7365 7367 +4305 111 7369 7368 7370 +4306 111 7372 7371 7373 +4307 111 7375 7374 7376 +4308 111 7378 7377 7379 +4309 111 7381 7380 7382 +4310 111 7384 7383 7385 +4311 111 7387 7386 7388 +4312 111 7390 7389 7391 +4313 111 7393 7392 7394 +4314 111 7396 7395 7397 +4315 111 7399 7398 7400 +4316 111 7402 7401 7403 +4317 111 7405 7404 7406 +4318 111 7408 7407 7409 +4319 111 7411 7410 7412 +4320 111 7414 7413 7415 +4321 111 7417 7416 7418 +4322 111 7420 7419 7421 +4323 111 7423 7422 7424 +4324 111 7426 7425 7427 +4325 111 7429 7428 7430 +4326 111 7432 7431 7433 +4327 111 7435 7434 7436 +4328 111 7438 7437 7439 +4329 111 7441 7440 7442 +4330 111 7444 7443 7445 +4331 111 7447 7446 7448 +4332 111 7450 7449 7451 +4333 111 7453 7452 7454 +4334 111 7456 7455 7457 +4335 111 7459 7458 7460 +4336 111 7462 7461 7463 +4337 111 7465 7464 7466 +4338 111 7468 7467 7469 +4339 111 7471 7470 7472 +4340 111 7474 7473 7475 +4341 111 7477 7476 7478 +4342 111 7480 7479 7481 +4343 111 7483 7482 7484 +4344 111 7486 7485 7487 +4345 111 7489 7488 7490 +4346 111 7492 7491 7493 +4347 111 7495 7494 7496 +4348 111 7498 7497 7499 +4349 111 7501 7500 7502 +4350 111 7504 7503 7505 +4351 111 7507 7506 7508 +4352 111 7510 7509 7511 +4353 111 7513 7512 7514 +4354 111 7516 7515 7517 +4355 111 7519 7518 7520 +4356 111 7522 7521 7523 +4357 111 7525 7524 7526 +4358 111 7528 7527 7529 +4359 111 7531 7530 7532 +4360 111 7534 7533 7535 +4361 111 7537 7536 7538 +4362 111 7540 7539 7541 +4363 111 7543 7542 7544 +4364 111 7546 7545 7547 +4365 111 7549 7548 7550 +4366 111 7552 7551 7553 +4367 111 7555 7554 7556 +4368 111 7558 7557 7559 +4369 111 7561 7560 7562 +4370 111 7564 7563 7565 +4371 111 7567 7566 7568 +4372 111 7570 7569 7571 +4373 111 7573 7572 7574 +4374 111 7576 7575 7577 +4375 111 7579 7578 7580 +4376 111 7582 7581 7583 +4377 111 7585 7584 7586 +4378 111 7588 7587 7589 +4379 111 7591 7590 7592 +4380 111 7594 7593 7595 +4381 111 7597 7596 7598 +4382 111 7600 7599 7601 +4383 111 7603 7602 7604 +4384 111 7606 7605 7607 +4385 111 7609 7608 7610 +4386 111 7612 7611 7613 +4387 111 7615 7614 7616 +4388 111 7618 7617 7619 +4389 111 7621 7620 7622 +4390 111 7624 7623 7625 +4391 111 7627 7626 7628 +4392 111 7630 7629 7631 +4393 111 7633 7632 7634 +4394 111 7636 7635 7637 +4395 111 7639 7638 7640 +4396 111 7642 7641 7643 +4397 111 7645 7644 7646 +4398 111 7648 7647 7649 +4399 111 7651 7650 7652 +4400 111 7654 7653 7655 +4401 111 7657 7656 7658 +4402 111 7660 7659 7661 +4403 111 7663 7662 7664 +4404 111 7666 7665 7667 +4405 111 7669 7668 7670 +4406 111 7672 7671 7673 +4407 111 7675 7674 7676 +4408 111 7678 7677 7679 +4409 111 7681 7680 7682 +4410 111 7684 7683 7685 +4411 111 7687 7686 7688 +4412 111 7690 7689 7691 +4413 111 7693 7692 7694 +4414 111 7696 7695 7697 +4415 111 7699 7698 7700 +4416 111 7702 7701 7703 +4417 111 7705 7704 7706 +4418 111 7708 7707 7709 +4419 111 7711 7710 7712 +4420 111 7714 7713 7715 +4421 111 7717 7716 7718 +4422 111 7720 7719 7721 +4423 111 7723 7722 7724 +4424 111 7726 7725 7727 +4425 111 7729 7728 7730 +4426 111 7732 7731 7733 +4427 111 7735 7734 7736 +4428 111 7738 7737 7739 +4429 111 7741 7740 7742 +4430 111 7744 7743 7745 +4431 111 7747 7746 7748 +4432 111 7750 7749 7751 +4433 111 7753 7752 7754 +4434 111 7756 7755 7757 +4435 111 7759 7758 7760 +4436 111 7762 7761 7763 +4437 111 7765 7764 7766 +4438 111 7768 7767 7769 +4439 111 7771 7770 7772 +4440 111 7774 7773 7775 +4441 111 7777 7776 7778 +4442 111 7780 7779 7781 +4443 111 7783 7782 7784 +4444 111 7786 7785 7787 +4445 111 7789 7788 7790 +4446 111 7792 7791 7793 +4447 111 7795 7794 7796 +4448 111 7798 7797 7799 +4449 111 7801 7800 7802 +4450 111 7804 7803 7805 +4451 111 7807 7806 7808 +4452 111 7810 7809 7811 +4453 111 7813 7812 7814 +4454 111 7816 7815 7817 +4455 111 7819 7818 7820 +4456 111 7822 7821 7823 +4457 111 7825 7824 7826 +4458 111 7828 7827 7829 +4459 111 7831 7830 7832 +4460 111 7834 7833 7835 +4461 111 7837 7836 7838 +4462 111 7840 7839 7841 +4463 111 7843 7842 7844 +4464 111 7846 7845 7847 +4465 111 7849 7848 7850 +4466 111 7852 7851 7853 +4467 111 7855 7854 7856 +4468 111 7858 7857 7859 +4469 111 7861 7860 7862 +4470 111 7864 7863 7865 +4471 111 7867 7866 7868 +4472 111 7870 7869 7871 +4473 111 7873 7872 7874 +4474 111 7876 7875 7877 +4475 111 7879 7878 7880 +4476 111 7882 7881 7883 +4477 111 7885 7884 7886 +4478 111 7888 7887 7889 +4479 111 7891 7890 7892 +4480 111 7894 7893 7895 +4481 111 7897 7896 7898 +4482 111 7900 7899 7901 +4483 111 7903 7902 7904 +4484 111 7906 7905 7907 +4485 111 7909 7908 7910 +4486 111 7912 7911 7913 +4487 111 7915 7914 7916 +4488 111 7918 7917 7919 +4489 111 7921 7920 7922 +4490 111 7924 7923 7925 +4491 111 7927 7926 7928 +4492 111 7930 7929 7931 +4493 111 7933 7932 7934 +4494 111 7936 7935 7937 +4495 111 7939 7938 7940 +4496 111 7942 7941 7943 +4497 111 7945 7944 7946 +4498 111 7948 7947 7949 +4499 111 7951 7950 7952 +4500 111 7954 7953 7955 +4501 111 7957 7956 7958 +4502 111 7960 7959 7961 +4503 111 7963 7962 7964 +4504 111 7966 7965 7967 +4505 111 7969 7968 7970 +4506 111 7972 7971 7973 +4507 111 7975 7974 7976 +4508 111 7978 7977 7979 +4509 111 7981 7980 7982 +4510 111 7984 7983 7985 +4511 111 7987 7986 7988 +4512 111 7990 7989 7991 +4513 111 7993 7992 7994 +4514 111 7996 7995 7997 +4515 111 7999 7998 8000 +4516 111 8002 8001 8003 +4517 111 8005 8004 8006 +4518 111 8008 8007 8009 +4519 111 8011 8010 8012 +4520 111 8014 8013 8015 +4521 111 8017 8016 8018 +4522 111 8020 8019 8021 +4523 111 8023 8022 8024 +4524 111 8026 8025 8027 +4525 111 8029 8028 8030 +4526 111 8032 8031 8033 +4527 111 8035 8034 8036 +4528 111 8038 8037 8039 +4529 111 8041 8040 8042 +4530 111 8044 8043 8045 +4531 111 8047 8046 8048 +4532 111 8050 8049 8051 +4533 111 8053 8052 8054 +4534 111 8056 8055 8057 +4535 111 8059 8058 8060 +4536 111 8062 8061 8063 +4537 111 8065 8064 8066 +4538 111 8068 8067 8069 +4539 111 8071 8070 8072 +4540 111 8074 8073 8075 +4541 111 8077 8076 8078 +4542 111 8080 8079 8081 +4543 111 8083 8082 8084 +4544 111 8086 8085 8087 +4545 111 8089 8088 8090 +4546 111 8092 8091 8093 +4547 111 8095 8094 8096 +4548 111 8098 8097 8099 +4549 111 8101 8100 8102 +4550 111 8104 8103 8105 +4551 111 8107 8106 8108 +4552 111 8110 8109 8111 +4553 111 8113 8112 8114 +4554 111 8116 8115 8117 +4555 111 8119 8118 8120 +4556 111 8122 8121 8123 +4557 111 8125 8124 8126 +4558 111 8128 8127 8129 +4559 111 8131 8130 8132 +4560 111 8134 8133 8135 +4561 111 8137 8136 8138 +4562 111 8140 8139 8141 +4563 111 8143 8142 8144 +4564 111 8146 8145 8147 +4565 111 8149 8148 8150 +4566 111 8152 8151 8153 +4567 111 8155 8154 8156 +4568 111 8158 8157 8159 +4569 111 8161 8160 8162 +4570 111 8164 8163 8165 +4571 111 8167 8166 8168 +4572 111 8170 8169 8171 +4573 111 8173 8172 8174 +4574 111 8176 8175 8177 +4575 111 8179 8178 8180 +4576 111 8182 8181 8183 +4577 111 8185 8184 8186 +4578 111 8188 8187 8189 +4579 111 8191 8190 8192 +4580 111 8194 8193 8195 +4581 111 8197 8196 8198 +4582 111 8200 8199 8201 +4583 111 8203 8202 8204 +4584 111 8206 8205 8207 +4585 111 8209 8208 8210 +4586 111 8212 8211 8213 +4587 111 8215 8214 8216 +4588 111 8218 8217 8219 +4589 111 8221 8220 8222 +4590 111 8224 8223 8225 +4591 111 8227 8226 8228 +4592 111 8230 8229 8231 +4593 111 8233 8232 8234 +4594 111 8236 8235 8237 +4595 111 8239 8238 8240 +4596 111 8242 8241 8243 +4597 111 8245 8244 8246 +4598 111 8248 8247 8249 +4599 111 8251 8250 8252 +4600 111 8254 8253 8255 +4601 111 8257 8256 8258 +4602 111 8260 8259 8261 +4603 111 8263 8262 8264 +4604 111 8266 8265 8267 +4605 111 8269 8268 8270 +4606 111 8272 8271 8273 +4607 111 8275 8274 8276 +4608 111 8278 8277 8279 +4609 111 8281 8280 8282 +4610 111 8284 8283 8285 +4611 111 8287 8286 8288 +4612 111 8290 8289 8291 +4613 111 8293 8292 8294 +4614 111 8296 8295 8297 +4615 111 8299 8298 8300 +4616 111 8302 8301 8303 +4617 111 8305 8304 8306 +4618 111 8308 8307 8309 +4619 111 8311 8310 8312 +4620 111 8314 8313 8315 +4621 111 8317 8316 8318 +4622 111 8320 8319 8321 +4623 111 8323 8322 8324 +4624 111 8326 8325 8327 +4625 111 8329 8328 8330 +4626 111 8332 8331 8333 +4627 111 8335 8334 8336 +4628 111 8338 8337 8339 +4629 111 8341 8340 8342 +4630 111 8344 8343 8345 +4631 111 8347 8346 8348 +4632 111 8350 8349 8351 +4633 111 8353 8352 8354 +4634 111 8356 8355 8357 +4635 111 8359 8358 8360 +4636 111 8362 8361 8363 +4637 111 8365 8364 8366 +4638 111 8368 8367 8369 +4639 111 8371 8370 8372 +4640 111 8374 8373 8375 +4641 111 8377 8376 8378 +4642 111 8380 8379 8381 +4643 111 8383 8382 8384 +4644 111 8386 8385 8387 +4645 111 8389 8388 8390 +4646 111 8392 8391 8393 +4647 111 8395 8394 8396 +4648 111 8398 8397 8399 +4649 111 8401 8400 8402 +4650 111 8404 8403 8405 +4651 111 8407 8406 8408 +4652 111 8410 8409 8411 +4653 111 8413 8412 8414 +4654 111 8416 8415 8417 +4655 111 8419 8418 8420 +4656 111 8422 8421 8423 +4657 111 8425 8424 8426 +4658 111 8428 8427 8429 +4659 111 8431 8430 8432 +4660 111 8434 8433 8435 +4661 111 8437 8436 8438 +4662 111 8440 8439 8441 +4663 111 8443 8442 8444 +4664 111 8446 8445 8447 +4665 111 8449 8448 8450 +4666 111 8452 8451 8453 +4667 111 8455 8454 8456 +4668 111 8458 8457 8459 +4669 111 8461 8460 8462 +4670 111 8464 8463 8465 +4671 111 8467 8466 8468 +4672 111 8470 8469 8471 +4673 111 8473 8472 8474 +4674 111 8476 8475 8477 +4675 111 8479 8478 8480 +4676 111 8482 8481 8483 +4677 111 8485 8484 8486 +4678 111 8488 8487 8489 +4679 111 8491 8490 8492 +4680 111 8494 8493 8495 +4681 111 8497 8496 8498 +4682 111 8500 8499 8501 +4683 111 8503 8502 8504 +4684 111 8506 8505 8507 +4685 111 8509 8508 8510 +4686 111 8512 8511 8513 +4687 111 8515 8514 8516 +4688 111 8518 8517 8519 +4689 111 8521 8520 8522 +4690 111 8524 8523 8525 +4691 111 8527 8526 8528 +4692 111 8530 8529 8531 +4693 111 8533 8532 8534 +4694 111 8536 8535 8537 +4695 111 8539 8538 8540 +4696 111 8542 8541 8543 +4697 111 8545 8544 8546 +4698 111 8548 8547 8549 +4699 111 8551 8550 8552 +4700 111 8554 8553 8555 +4701 111 8557 8556 8558 +4702 111 8560 8559 8561 +4703 111 8563 8562 8564 +4704 111 8566 8565 8567 +4705 111 8569 8568 8570 +4706 111 8572 8571 8573 +4707 111 8575 8574 8576 +4708 111 8578 8577 8579 +4709 111 8581 8580 8582 +4710 111 8584 8583 8585 +4711 111 8587 8586 8588 +4712 111 8590 8589 8591 +4713 111 8593 8592 8594 +4714 111 8596 8595 8597 +4715 111 8599 8598 8600 +4716 111 8602 8601 8603 +4717 111 8605 8604 8606 +4718 111 8608 8607 8609 +4719 111 8611 8610 8612 +4720 111 8614 8613 8615 +4721 111 8617 8616 8618 +4722 111 8620 8619 8621 +4723 111 8623 8622 8624 +4724 111 8626 8625 8627 +4725 111 8629 8628 8630 +4726 111 8632 8631 8633 +4727 111 8635 8634 8636 +4728 111 8638 8637 8639 +4729 111 8641 8640 8642 +4730 111 8644 8643 8645 +4731 111 8647 8646 8648 +4732 111 8650 8649 8651 +4733 111 8653 8652 8654 +4734 111 8656 8655 8657 +4735 111 8659 8658 8660 +4736 111 8662 8661 8663 +4737 111 8665 8664 8666 +4738 111 8668 8667 8669 +4739 111 8671 8670 8672 +4740 111 8674 8673 8675 +4741 111 8677 8676 8678 +4742 111 8680 8679 8681 +4743 111 8683 8682 8684 +4744 111 8686 8685 8687 +4745 111 8689 8688 8690 +4746 111 8692 8691 8693 +4747 111 8695 8694 8696 +4748 111 8698 8697 8699 +4749 111 8701 8700 8702 +4750 111 8704 8703 8705 +4751 111 8707 8706 8708 +4752 111 8710 8709 8711 +4753 111 8713 8712 8714 +4754 111 8716 8715 8717 +4755 111 8719 8718 8720 +4756 111 8722 8721 8723 +4757 111 8725 8724 8726 +4758 111 8728 8727 8729 +4759 111 8731 8730 8732 +4760 111 8734 8733 8735 +4761 111 8737 8736 8738 +4762 111 8740 8739 8741 +4763 111 8743 8742 8744 +4764 111 8746 8745 8747 +4765 111 8749 8748 8750 +4766 111 8752 8751 8753 +4767 111 8755 8754 8756 +4768 111 8758 8757 8759 +4769 111 8761 8760 8762 +4770 111 8764 8763 8765 +4771 111 8767 8766 8768 +4772 111 8770 8769 8771 +4773 111 8773 8772 8774 +4774 111 8776 8775 8777 +4775 111 8779 8778 8780 +4776 111 8782 8781 8783 +4777 111 8785 8784 8786 +4778 111 8788 8787 8789 +4779 111 8791 8790 8792 +4780 111 8794 8793 8795 +4781 111 8797 8796 8798 +4782 111 8800 8799 8801 +4783 111 8803 8802 8804 +4784 111 8806 8805 8807 +4785 111 8809 8808 8810 +4786 111 8812 8811 8813 +4787 111 8815 8814 8816 +4788 111 8818 8817 8819 +4789 111 8821 8820 8822 +4790 111 8824 8823 8825 +4791 111 8827 8826 8828 +4792 111 8830 8829 8831 +4793 111 8833 8832 8834 +4794 111 8836 8835 8837 +4795 111 8839 8838 8840 +4796 111 8842 8841 8843 +4797 111 8845 8844 8846 +4798 111 8848 8847 8849 +4799 111 8851 8850 8852 +4800 111 8854 8853 8855 +4801 111 8857 8856 8858 +4802 111 8860 8859 8861 +4803 111 8863 8862 8864 +4804 111 8866 8865 8867 +4805 111 8869 8868 8870 +4806 111 8872 8871 8873 +4807 111 8875 8874 8876 +4808 111 8878 8877 8879 +4809 111 8881 8880 8882 +4810 111 8884 8883 8885 +4811 111 8887 8886 8888 +4812 111 8890 8889 8891 +4813 111 8893 8892 8894 +4814 111 8896 8895 8897 +4815 111 8899 8898 8900 +4816 111 8902 8901 8903 +4817 111 8905 8904 8906 +4818 111 8908 8907 8909 +4819 111 8911 8910 8912 +4820 111 8914 8913 8915 +4821 111 8917 8916 8918 +4822 111 8920 8919 8921 +4823 111 8923 8922 8924 +4824 111 8926 8925 8927 +4825 111 8929 8928 8930 +4826 111 8932 8931 8933 +4827 111 8935 8934 8936 +4828 111 8938 8937 8939 +4829 111 8941 8940 8942 +4830 111 8944 8943 8945 +4831 111 8947 8946 8948 +4832 111 8950 8949 8951 +4833 111 8953 8952 8954 +4834 111 8956 8955 8957 +4835 111 8959 8958 8960 +4836 111 8962 8961 8963 +4837 111 8965 8964 8966 +4838 111 8968 8967 8969 +4839 111 8971 8970 8972 +4840 111 8974 8973 8975 +4841 111 8977 8976 8978 +4842 111 8980 8979 8981 +4843 111 8983 8982 8984 +4844 111 8986 8985 8987 +4845 111 8989 8988 8990 +4846 111 8992 8991 8993 +4847 111 8995 8994 8996 +4848 111 8998 8997 8999 +4849 111 9001 9000 9002 +4850 111 9004 9003 9005 +4851 111 9007 9006 9008 +4852 111 9010 9009 9011 +4853 111 9013 9012 9014 +4854 111 9016 9015 9017 +4855 111 9019 9018 9020 +4856 111 9022 9021 9023 +4857 111 9025 9024 9026 +4858 111 9028 9027 9029 +4859 111 9031 9030 9032 +4860 111 9034 9033 9035 +4861 111 9037 9036 9038 +4862 111 9040 9039 9041 +4863 111 9043 9042 9044 +4864 111 9046 9045 9047 +4865 111 9049 9048 9050 +4866 111 9052 9051 9053 +4867 111 9055 9054 9056 +4868 111 9058 9057 9059 +4869 111 9061 9060 9062 +4870 111 9064 9063 9065 +4871 111 9067 9066 9068 +4872 111 9070 9069 9071 +4873 111 9073 9072 9074 +4874 111 9076 9075 9077 +4875 111 9079 9078 9080 +4876 111 9082 9081 9083 +4877 111 9085 9084 9086 +4878 111 9088 9087 9089 +4879 111 9091 9090 9092 +4880 111 9094 9093 9095 +4881 111 9097 9096 9098 +4882 111 9100 9099 9101 +4883 111 9103 9102 9104 +4884 111 9106 9105 9107 +4885 111 9109 9108 9110 +4886 111 9112 9111 9113 +4887 111 9115 9114 9116 +4888 111 9118 9117 9119 +4889 111 9121 9120 9122 +4890 111 9124 9123 9125 +4891 111 9127 9126 9128 +4892 111 9130 9129 9131 +4893 111 9133 9132 9134 +4894 111 9136 9135 9137 +4895 111 9139 9138 9140 +4896 111 9142 9141 9143 +4897 111 9145 9144 9146 +4898 111 9148 9147 9149 +4899 111 9151 9150 9152 +4900 111 9154 9153 9155 +4901 111 9157 9156 9158 +4902 111 9160 9159 9161 +4903 111 9163 9162 9164 +4904 111 9166 9165 9167 +4905 111 9169 9168 9170 +4906 111 9172 9171 9173 +4907 111 9175 9174 9176 +4908 111 9178 9177 9179 +4909 111 9181 9180 9182 +4910 111 9184 9183 9185 +4911 111 9187 9186 9188 +4912 111 9190 9189 9191 +4913 111 9193 9192 9194 +4914 111 9196 9195 9197 +4915 111 9199 9198 9200 +4916 111 9202 9201 9203 +4917 111 9205 9204 9206 +4918 111 9208 9207 9209 +4919 111 9211 9210 9212 +4920 111 9214 9213 9215 +4921 111 9217 9216 9218 +4922 111 9220 9219 9221 +4923 111 9223 9222 9224 +4924 111 9226 9225 9227 +4925 111 9229 9228 9230 +4926 111 9232 9231 9233 +4927 111 9235 9234 9236 +4928 111 9238 9237 9239 +4929 111 9241 9240 9242 +4930 111 9244 9243 9245 +4931 111 9247 9246 9248 +4932 111 9250 9249 9251 +4933 111 9253 9252 9254 +4934 111 9256 9255 9257 +4935 111 9259 9258 9260 +4936 111 9262 9261 9263 +4937 111 9265 9264 9266 +4938 111 9268 9267 9269 +4939 111 9271 9270 9272 +4940 111 9274 9273 9275 +4941 111 9277 9276 9278 +4942 111 9280 9279 9281 +4943 111 9283 9282 9284 +4944 111 9286 9285 9287 +4945 111 9289 9288 9290 +4946 111 9292 9291 9293 +4947 111 9295 9294 9296 +4948 111 9298 9297 9299 +4949 111 9301 9300 9302 +4950 111 9304 9303 9305 +4951 111 9307 9306 9308 +4952 111 9310 9309 9311 +4953 111 9313 9312 9314 +4954 111 9316 9315 9317 +4955 111 9319 9318 9320 +4956 111 9322 9321 9323 +4957 111 9325 9324 9326 +4958 111 9328 9327 9329 +4959 111 9331 9330 9332 +4960 111 9334 9333 9335 +4961 111 9337 9336 9338 +4962 111 9340 9339 9341 +4963 111 9343 9342 9344 +4964 111 9346 9345 9347 +4965 111 9349 9348 9350 +4966 111 9352 9351 9353 +4967 111 9355 9354 9356 +4968 111 9358 9357 9359 +4969 111 9361 9360 9362 +4970 111 9364 9363 9365 +4971 111 9367 9366 9368 +4972 111 9370 9369 9371 +4973 111 9373 9372 9374 +4974 111 9376 9375 9377 +4975 111 9379 9378 9380 +4976 111 9382 9381 9383 +4977 111 9385 9384 9386 +4978 111 9388 9387 9389 +4979 111 9391 9390 9392 +4980 111 9394 9393 9395 +4981 111 9397 9396 9398 +4982 111 9400 9399 9401 +4983 111 9403 9402 9404 +4984 111 9406 9405 9407 +4985 111 9409 9408 9410 +4986 111 9412 9411 9413 +4987 111 9415 9414 9416 +4988 111 9418 9417 9419 +4989 111 9421 9420 9422 +4990 111 9424 9423 9425 +4991 111 9427 9426 9428 +4992 111 9430 9429 9431 +4993 111 9433 9432 9434 +4994 111 9436 9435 9437 +4995 111 9439 9438 9440 +4996 111 9442 9441 9443 +4997 111 9445 9444 9446 +4998 111 9448 9447 9449 +4999 111 9451 9450 9452 +5000 111 9454 9453 9455 +5001 111 9457 9456 9458 +5002 111 9460 9459 9461 +5003 111 9463 9462 9464 +5004 111 9466 9465 9467 +5005 111 9469 9468 9470 +5006 111 9472 9471 9473 +5007 111 9475 9474 9476 +5008 111 9478 9477 9479 +5009 111 9481 9480 9482 +5010 111 9484 9483 9485 +5011 111 9487 9486 9488 +5012 111 9490 9489 9491 +5013 111 9493 9492 9494 +5014 111 9496 9495 9497 +5015 111 9499 9498 9500 +5016 111 9502 9501 9503 +5017 111 9505 9504 9506 +5018 111 9508 9507 9509 +5019 111 9511 9510 9512 +5020 111 9514 9513 9515 +5021 111 9517 9516 9518 +5022 111 9520 9519 9521 +5023 111 9523 9522 9524 +5024 111 9526 9525 9527 +5025 111 9529 9528 9530 +5026 111 9532 9531 9533 +5027 111 9535 9534 9536 +5028 111 9538 9537 9539 +5029 111 9541 9540 9542 +5030 111 9544 9543 9545 +5031 111 9547 9546 9548 +5032 111 9550 9549 9551 +5033 111 9553 9552 9554 +5034 111 9556 9555 9557 +5035 111 9559 9558 9560 +5036 111 9562 9561 9563 +5037 111 9565 9564 9566 +5038 111 9568 9567 9569 +5039 111 9571 9570 9572 +5040 111 9574 9573 9575 +5041 111 9577 9576 9578 +5042 111 9580 9579 9581 +5043 111 9583 9582 9584 +5044 111 9586 9585 9587 +5045 111 9589 9588 9590 +5046 111 9592 9591 9593 +5047 111 9595 9594 9596 +5048 111 9598 9597 9599 +5049 111 9601 9600 9602 +5050 111 9604 9603 9605 +5051 111 9607 9606 9608 +5052 111 9610 9609 9611 +5053 111 9613 9612 9614 +5054 111 9616 9615 9617 +5055 111 9619 9618 9620 +5056 111 9622 9621 9623 +5057 111 9625 9624 9626 +5058 111 9628 9627 9629 +5059 111 9631 9630 9632 +5060 111 9634 9633 9635 +5061 111 9637 9636 9638 +5062 111 9640 9639 9641 +5063 111 9643 9642 9644 +5064 111 9646 9645 9647 +5065 111 9649 9648 9650 +5066 111 9652 9651 9653 +5067 111 9655 9654 9656 +5068 111 9658 9657 9659 +5069 111 9661 9660 9662 +5070 111 9664 9663 9665 +5071 111 9667 9666 9668 +5072 111 9670 9669 9671 +5073 111 9673 9672 9674 +5074 111 9676 9675 9677 +5075 111 9679 9678 9680 +5076 111 9682 9681 9683 +5077 111 9685 9684 9686 +5078 111 9688 9687 9689 +5079 111 9691 9690 9692 +5080 111 9694 9693 9695 +5081 111 9697 9696 9698 +5082 111 9700 9699 9701 +5083 111 9703 9702 9704 +5084 111 9706 9705 9707 +5085 111 9709 9708 9710 +5086 111 9712 9711 9713 +5087 111 9715 9714 9716 +5088 111 9718 9717 9719 +5089 111 9721 9720 9722 +5090 111 9724 9723 9725 +5091 111 9727 9726 9728 +5092 111 9730 9729 9731 +5093 111 9733 9732 9734 +5094 111 9736 9735 9737 + +Bond Coeffs + +1 1.448 381.3 -972.315 1446.3185625 +2 1.015 461.9 -1177.845 1752.0444375 +3 1.509 345.0 -879.75 1308.628125 +4 1.112 341.0 -869.55 1293.455625 +5 1.525 323.0 -823.65 1225.179375 +6 1.2255 662.0 -1688.1 2511.04875 +7 1.345 482.0 -1229.1 1828.28625 +8 1.525 323.0 -823.65 1225.179375 +9 1.112 341.0 -869.55 1293.455625 +10 1.805 215.8 -550.29 818.556375 +11 1.437 375.0 -956.25 1422.421875 +12 1.028 487.0 -1241.85 1847.251875 +13 1.509 345.0 -879.75 1308.628125 +14 1.525 323.0 -823.65 1225.179375 +15 1.499 453.2 -1155.66 1719.04425 +16 1.3887 471.9 -1203.345 1789.9756875 +17 1.1 370.5 -944.775 1405.3528125 +18 1.448 381.3 -972.315 1446.3185625 +19 1.015 461.9 -1177.845 1752.0444375 +20 1.413 410.0 -1045.5 1555.18125 +21 0.947 548.9 -1399.695 2082.0463125 +22 1.437 375.0 -956.25 1422.421875 +23 1.509 345.0 -879.75 1308.628125 +24 1.112 341.0 -869.55 1293.455625 +25 1.509 345.0 -879.75 1308.628125 +26 1.2553 705.0 -1797.75 2674.153125 +27 1.345 482.0 -1229.1 1828.28625 +28 1.437 375.0 -956.25 1422.421875 +29 1.437 375.0 -956.25 1422.421875 +30 1.525 323.0 -823.65 1225.179375 +31 1.5247 323.0 -823.65 1225.179375 +32 1.112 341.0 -869.55 1293.455625 +33 1.112 341.0 -869.55 1293.455625 +34 1.413 410.0 -1045.5 1555.18125 +35 1.446 374.8 -955.74 1421.66325 +36 1.325 491.4 -1253.07 1863.941625 +37 1.028 487.0 -1241.85 1847.251875 +38 1.355 431.6 -1100.58 1637.11275 +39 0.947 548.9 -1399.695 2082.0463125 +40 1.493 453.2 -1155.66 1719.04425 +41 1.373 653.9 -1667.445 2480.3244375 +42 1.371 539.6 -1375.98 2046.77025 +43 1.352 653.9 -1667.445 2480.3244375 +44 1.03 467.6 -1192.38 1773.66525 +45 1.081 370.5 -944.775 1405.3528125 +46 1.081 370.5 -944.775 1405.3528125 +47 1.509 345.0 -879.75 1308.628125 +48 0.9572 556.85 -1419.9675 2112.20165625 + +Angle Coeffs + +1 0 108.5 43.2 -34.6524874495 7.94176512195 -5.68787029215 10.2422873821 +2 0 105.4 43.2 -34.6524874495 7.94176512195 -5.68787029215 10.2422873821 +3 0 110.7 75.2 -60.3209966714 13.8245541012 -9.90110754559 17.8291669244 +4 0 109.3 59.0 -47.3263138778 10.8463921804 -7.76815618604 13.9883091561 +5 0 110.7 75.2 -60.3209966714 13.8245541012 -9.90110754559 17.8291669244 +6 0 109.5 39.0 -31.2834956141 7.16964906843 -5.13488290263 9.24650944218 +7 0 110.6 58.0 -46.5241729646 10.6625550248 -7.63649252187 13.7512191704 +8 0 112.8 42.0 -33.6899183537 7.72116053523 -5.52987389514 9.95777939927 +9 1 122.4 80.0 -64.1712730547 14.7069724481 -10.5330931336 18.9671988558 +10 1 113.4 70.0 -56.1498639228 12.868600892 -9.21645649191 16.5962989988 +11 1 124.2 77.0 -61.7648503151 14.1554609813 -10.1381021411 18.2559288987 +12 2 111.0 48.2 -38.6631920154 8.86095089995 -6.346188613 11.4277373106 +13 0 110.7 42.0 -33.6899183537 7.72116053523 -5.52987389514 9.95777939927 +14 0 110.7 42.0 -33.6899183537 7.72116053523 -5.52987389514 9.95777939927 +15 0 107.8 40.0 -32.0856365273 7.35348622403 -5.2665465668 9.48359942788 +16 2 110.1 53.2 -42.6738965813 9.78013667795 -7.00450693385 12.6131872391 +17 2 110.8 53.2 -42.6738965813 9.78013667795 -7.00450693385 12.6131872391 +18 0 95.9 60.4 -48.4493111563 11.1037641983 -7.95248531587 14.3202351361 +19 2 108.0 53.2 -42.6738965813 9.78013667795 -7.00450693385 12.6131872391 +20 1 122.0 50.0 -40.1070456592 9.19185778003 -6.5831832085 11.8544992848 +21 1 121.0 36.0 -28.8770728746 6.61813760162 -4.73989191012 8.53523948509 +22 1 117.0 32.0 -25.6685092219 5.88278897922 -4.21323725344 7.5868795423 +23 0 109.6 61.0 -48.9305957042 11.2140664916 -8.03148351438 14.4624891275 +24 0 111.0 55.0 -44.1177502251 10.111043558 -7.24150152936 13.0399492133 +25 0 111.3 54.0 -43.3156093119 9.92720640244 -7.10983786519 12.8028592276 +26 0 110.6 47.6 -38.1819074675 8.75064860659 -6.2671904145 11.2854833192 +27 0 109.5 39.0 -31.2834956141 7.16964906843 -5.13488290263 9.24650944218 +28 1 122.4 80.0 -64.1712730547 14.7069724481 -10.5330931336 18.9671988558 +29 1 113.4 70.0 -56.1498639228 12.868600892 -9.21645649191 16.5962989988 +30 1 123.0 29.5 -23.6631569389 5.42319609022 -3.88407809302 6.99415457806 +31 0 111.3 54.0 -43.3156093119 9.92720640244 -7.10983786519 12.8028592276 +32 0 110.6 58.0 -46.5241729646 10.6625550248 -7.63649252187 13.7512191704 +33 0 110.7 42.0 -33.6899183537 7.72116053523 -5.52987389514 9.95777939927 +34 2 110.2 48.2 -38.6631920154 8.86095089995 -6.346188613 11.4277373106 +35 2 110.2 48.2 -38.6631920154 8.86095089995 -6.346188613 11.4277373106 +36 0 110.6 38.9 -31.2032815228 7.15126535287 -5.12171653622 9.22280044361 +37 2 109.3 39.6 -31.7647801621 7.27995136179 -5.21388110114 9.3887634336 +38 1 122.3 33.8 -27.1123628656 6.2136958593 -4.45023184895 8.01364151656 +39 1 121.7 54.7 -43.8771079511 10.0558924114 -7.2020024301 12.9688222176 +40 2 120.0 35.3 -28.3155742354 6.4894515927 -4.6477273452 8.3692764951 +41 2 111.0 48.2 -38.6631920154 8.86095089995 -6.346188613 11.4277373106 +42 0 109.5 56.1 -45.0001052296 10.3132644292 -7.38633155994 13.3007481976 +43 0 109.3 59.0 -47.3263138778 10.8463921804 -7.76815618604 13.9883091561 +44 0 110.9 43.2 -34.6524874495 7.94176512195 -5.68787029215 10.2422873821 +45 0 107.0 43.5 -34.8931297235 7.99691626863 -5.7273693914 10.3134143778 +46 0 107.5 59.7 -47.887812517 10.9750781894 -7.86032075095 14.1542721461 +47 0 107.5 59.7 -47.887812517 10.9750781894 -7.86032075095 14.1542721461 +48 2 110.0 59.0 -47.3263138778 10.8463921804 -7.76815618604 13.9883091561 +49 0 106.8 54.0 -43.3156093119 9.92720640244 -7.10983786519 12.8028592276 +50 2 111.0 48.2 -38.6631920154 8.86095089995 -6.346188613 11.4277373106 +51 1 122.0 50.0 -40.1070456592 9.19185778003 -6.5831832085 11.8544992848 +52 1 117.0 32.0 -25.6685092219 5.88278897922 -4.21323725344 7.5868795423 +53 0 109.8 55.0 -44.1177502251 10.111043558 -7.24150152936 13.0399492133 +54 0 111.0 55.0 -44.1177502251 10.111043558 -7.24150152936 13.0399492133 +55 0 109.5 39.0 -31.2834956141 7.16964906843 -5.13488290263 9.24650944218 +56 0 107.6 40.0 -32.0856365273 7.35348622403 -5.2665465668 9.48359942788 +57 1 122.4 80.0 -64.1712730547 14.7069724481 -10.5330931336 18.9671988558 +58 1 113.4 70.0 -56.1498639228 12.868600892 -9.21645649191 16.5962989988 +59 0 110.6 47.6 -38.1819074675 8.75064860659 -6.2671904145 11.2854833192 +60 0 109.5 39.0 -31.2834956141 7.16964906843 -5.13488290263 9.24650944218 +61 1 122.4 80.0 -64.1712730547 14.7069724481 -10.5330931336 18.9671988558 +62 1 134.0 57.6 -46.2033165993 10.5890201626 -7.5838270562 13.6563831761 +63 1 113.4 70.0 -56.1498639228 12.868600892 -9.21645649191 16.5962989988 +64 1 124.2 77.0 -61.7648503151 14.1554609813 -10.1381021411 18.2559288987 +65 1 122.0 50.0 -40.1070456592 9.19185778003 -6.5831832085 11.8544992848 +66 1 122.0 50.0 -40.1070456592 9.19185778003 -6.5831832085 11.8544992848 +67 1 112.5 54.7 -43.8771079511 10.0558924114 -7.2020024301 12.9688222176 +68 0 109.6 61.0 -48.9305957042 11.2140664916 -8.03148351438 14.4624891275 +69 0 111.0 55.0 -44.1177502251 10.111043558 -7.24150152936 13.0399492133 +70 0 104.0 54.0 -43.3156093119 9.92720640244 -7.10983786519 12.8028592276 +71 0 110.6 58.0 -46.5241729646 10.6625550248 -7.63649252187 13.7512191704 +72 0 112.8 42.0 -33.6899183537 7.72116053523 -5.52987389514 9.95777939927 +73 0 104.0 48.2 -38.6631920154 8.86095089995 -6.346188613 11.4277373106 +74 0 110.7 42.0 -33.6899183537 7.72116053523 -5.52987389514 9.95777939927 +75 0 110.7 42.0 -33.6899183537 7.72116053523 -5.52987389514 9.95777939927 +76 0 107.8 40.0 -32.0856365273 7.35348622403 -5.2665465668 9.48359942788 +77 0 104.0 48.2 -38.6631920154 8.86095089995 -6.346188613 11.4277373106 +78 0 104.0 54.0 -43.3156093119 9.92720640244 -7.10983786519 12.8028592276 +79 0 111.0 55.0 -44.1177502251 10.111043558 -7.24150152936 13.0399492133 +80 0 110.7 42.0 -33.6899183537 7.72116053523 -5.52987389514 9.95777939927 +81 0 107.8 40.0 -32.0856365273 7.35348622403 -5.2665465668 9.48359942788 +82 0 107.5 59.7 -47.887812517 10.9750781894 -7.86032075095 14.1542721461 +83 2 108.9 59.0 -47.3263138778 10.8463921804 -7.76815618604 13.9883091561 +84 0 106.8 54.0 -43.3156093119 9.92720640244 -7.10983786519 12.8028592276 +85 0 110.6 47.6 -38.1819074675 8.75064860659 -6.2671904145 11.2854833192 +86 0 110.6 47.6 -38.1819074675 8.75064860659 -6.2671904145 11.2854833192 +87 0 109.5 56.1 -45.0001052296 10.3132644292 -7.38633155994 13.3007481976 +88 0 111.0 54.6 -43.7968938598 10.0375086958 -7.18883606369 12.9451132191 +89 1 120.4 52.5 -42.1123979421 9.65145066903 -6.91234236893 12.4472242491 +90 1 122.4 13.7 -10.9893305106 2.51856903173 -1.80379219913 3.24813280405 +91 1 120.5 41.7 -33.4492760797 7.66600938855 -5.49037479589 9.88665240356 +92 1 120.0 28.8 -23.1016582997 5.2945100813 -3.7919135281 6.82819158807 +93 1 120.0 29.5 -23.6631569389 5.42319609022 -3.88407809302 6.99415457806 +94 1 120.0 43.2 -34.6524874495 7.94176512195 -5.68787029215 10.2422873821 +95 0 109.0 25.9 -20.7754496514 4.76138233006 -3.41008890201 6.14063062955 +96 0 112.7 38.8 -31.1230674315 7.13288163731 -5.1085501698 9.19909144504 +97 0 109.5 39.6 -31.7647801621 7.27995136179 -5.21388110114 9.3887634336 +98 1 122.0 36.0 -28.8770728746 6.61813760162 -4.73989191012 8.53523948509 +99 1 131.0 36.0 -28.8770728746 6.61813760162 -4.73989191012 8.53523948509 +100 1 104.7 47.5 -38.1016933762 8.73226489103 -6.25402404808 11.2617743206 +101 1 110.8 86.3 -69.2247608077 15.8651465283 -11.3625742179 20.4608657656 +102 1 125.5 35.3 -28.3155742354 6.4894515927 -4.6477273452 8.3692764951 +103 1 125.5 35.3 -28.3155742354 6.4894515927 -4.6477273452 8.3692764951 +104 1 128.0 35.3 -28.3155742354 6.4894515927 -4.6477273452 8.3692764951 +105 1 122.5 38.1 -30.5615687923 7.00419562839 -5.01638560488 9.03312845505 +106 1 110.3 28.8 -23.1016582997 5.2945100813 -3.7919135281 6.82819158807 +107 1 122.5 38.1 -30.5615687923 7.00419562839 -5.01638560488 9.03312845505 +108 0 109.6 61.0 -48.9305957042 11.2140664916 -8.03148351438 14.4624891275 +109 0 109.5 39.0 -31.2834956141 7.16964906843 -5.13488290263 9.24650944218 +110 1 122.4 80.0 -64.1712730547 14.7069724481 -10.5330931336 18.9671988558 +111 0 108.5 48.7 -39.064262472 8.95286947775 -6.41202044508 11.5462823034 + +Tinker Types + +1 234 +2 8 +3 9 +4 11 +5 235 +6 235 +7 235 +8 12 +9 178 +10 180 +11 182 +12 183 +13 179 +14 179 +15 181 +16 181 +17 184 +18 184 +19 184 +20 7 +21 8 +22 9 +23 11 +24 10 +25 12 +26 170 +27 172 +28 174 +29 175 +30 176 +31 171 +32 171 +33 173 +34 173 +35 177 +36 177 +37 7 +38 8 +39 9 +40 11 +41 10 +42 12 +43 25 +44 29 +45 27 +46 31 +47 26 +48 30 +49 30 +50 28 +51 28 +52 28 +53 32 +54 32 +55 32 +56 7 +57 8 +58 9 +59 11 +60 10 +61 12 +62 64 +63 66 +64 67 +65 67 +66 69 +67 69 +68 71 +69 65 +70 65 +71 68 +72 68 +73 70 +74 70 +75 72 +76 7 +77 8 +78 9 +79 11 +80 10 +81 12 +82 15 +83 17 +84 17 +85 16 +86 18 +87 18 +88 18 +89 18 +90 18 +91 18 +92 7 +93 8 +94 9 +95 11 +96 10 +97 12 +98 185 +99 187 +100 189 +101 191 +102 193 +103 186 +104 186 +105 188 +106 188 +107 190 +108 190 +109 192 +110 192 +111 194 +112 194 +113 194 +114 7 +115 33 +116 9 +117 11 +118 10 +119 12 +120 38 +121 42 +122 40 +123 39 +124 43 +125 41 +126 41 +127 41 +128 7 +129 8 +130 9 +131 11 +132 10 +133 12 +134 19 +135 21 +136 23 +137 23 +138 20 +139 20 +140 22 +141 24 +142 24 +143 24 +144 24 +145 24 +146 24 +147 7 +148 33 +149 9 +150 11 +151 10 +152 12 +153 38 +154 42 +155 40 +156 39 +157 43 +158 41 +159 41 +160 41 +161 1 +162 2 +163 3 +164 5 +165 4 +166 6 +167 6 +168 7 +169 8 +170 9 +171 11 +172 10 +173 12 +174 185 +175 187 +176 189 +177 191 +178 193 +179 186 +180 186 +181 188 +182 188 +183 190 +184 190 +185 192 +186 192 +187 194 +188 194 +189 194 +190 7 +191 33 +192 9 +193 11 +194 10 +195 12 +196 38 +197 42 +198 40 +199 39 +200 43 +201 41 +202 41 +203 41 +204 7 +205 8 +206 9 +207 11 +208 10 +209 12 +210 25 +211 29 +212 27 +213 31 +214 26 +215 30 +216 30 +217 28 +218 28 +219 28 +220 32 +221 32 +222 32 +223 7 +224 33 +225 9 +226 11 +227 10 +228 12 +229 38 +230 42 +231 40 +232 39 +233 43 +234 41 +235 41 +236 41 +237 7 +238 8 +239 9 +240 11 +241 10 +242 12 +243 19 +244 21 +245 23 +246 23 +247 20 +248 20 +249 22 +250 24 +251 24 +252 24 +253 24 +254 24 +255 24 +256 7 +257 8 +258 9 +259 11 +260 10 +261 12 +262 156 +263 158 +264 160 +265 161 +266 161 +267 157 +268 157 +269 159 +270 159 +271 7 +272 8 +273 9 +274 11 +275 10 +276 12 +277 15 +278 17 +279 17 +280 16 +281 18 +282 18 +283 18 +284 18 +285 18 +286 18 +287 7 +288 8 +289 9 +290 11 +291 10 +292 12 +293 156 +294 158 +295 160 +296 161 +297 161 +298 157 +299 157 +300 159 +301 159 +302 53 +303 54 +304 55 +305 56 +306 57 +307 58 +308 60 +309 62 +310 59 +311 59 +312 61 +313 61 +314 63 +315 63 +316 7 +317 33 +318 9 +319 11 +320 10 +321 12 +322 34 +323 36 +324 35 +325 35 +326 37 +327 7 +328 8 +329 9 +330 11 +331 10 +332 12 +333 140 +334 142 +335 143 +336 143 +337 141 +338 141 +339 7 +340 33 +341 9 +342 11 +343 10 +344 12 +345 38 +346 42 +347 40 +348 39 +349 43 +350 41 +351 41 +352 41 +353 7 +354 8 +355 9 +356 11 +357 10 +358 12 +359 25 +360 29 +361 27 +362 31 +363 26 +364 30 +365 30 +366 28 +367 28 +368 28 +369 32 +370 32 +371 32 +372 7 +373 8 +374 9 +375 11 +376 10 +377 12 +378 156 +379 158 +380 160 +381 161 +382 161 +383 157 +384 157 +385 159 +386 159 +387 7 +388 8 +389 9 +390 11 +391 10 +392 12 +393 150 +394 152 +395 153 +396 154 +397 151 +398 151 +399 155 +400 155 +401 7 +402 8 +403 9 +404 11 +405 10 +406 12 +407 15 +408 17 +409 17 +410 16 +411 18 +412 18 +413 18 +414 18 +415 18 +416 18 +417 7 +418 8 +419 9 +420 11 +421 10 +422 12 +423 185 +424 187 +425 189 +426 191 +427 193 +428 186 +429 186 +430 188 +431 188 +432 190 +433 190 +434 192 +435 192 +436 194 +437 194 +438 194 +439 7 +440 8 +441 9 +442 11 +443 10 +444 12 +445 13 +446 14 +447 14 +448 14 +449 7 +450 8 +451 9 +452 11 +453 10 +454 12 +455 185 +456 187 +457 189 +458 191 +459 193 +460 186 +461 186 +462 188 +463 188 +464 190 +465 190 +466 192 +467 192 +468 194 +469 194 +470 194 +471 7 +472 8 +473 9 +474 11 +475 10 +476 12 +477 25 +478 29 +479 27 +480 31 +481 26 +482 30 +483 30 +484 28 +485 28 +486 28 +487 32 +488 32 +489 32 +490 7 +491 8 +492 9 +493 11 +494 10 +495 12 +496 170 +497 172 +498 174 +499 175 +500 176 +501 171 +502 171 +503 173 +504 173 +505 177 +506 177 +507 7 +508 8 +509 9 +510 11 +511 10 +512 12 +513 140 +514 142 +515 143 +516 143 +517 141 +518 141 +519 7 +520 8 +521 9 +522 11 +523 10 +524 12 +525 185 +526 187 +527 189 +528 191 +529 193 +530 186 +531 186 +532 188 +533 188 +534 190 +535 190 +536 192 +537 192 +538 194 +539 194 +540 194 +541 7 +542 8 +543 9 +544 11 +545 10 +546 12 +547 156 +548 158 +549 160 +550 161 +551 161 +552 157 +553 157 +554 159 +555 159 +556 1 +557 2 +558 3 +559 5 +560 4 +561 6 +562 6 +563 7 +564 8 +565 9 +566 11 +567 10 +568 12 +569 25 +570 29 +571 27 +572 31 +573 26 +574 30 +575 30 +576 28 +577 28 +578 28 +579 32 +580 32 +581 32 +582 53 +583 54 +584 55 +585 56 +586 57 +587 58 +588 60 +589 62 +590 59 +591 59 +592 61 +593 61 +594 63 +595 63 +596 53 +597 54 +598 55 +599 56 +600 57 +601 58 +602 60 +603 62 +604 59 +605 59 +606 61 +607 61 +608 63 +609 63 +610 7 +611 8 +612 9 +613 11 +614 10 +615 12 +616 140 +617 142 +618 143 +619 143 +620 141 +621 141 +622 7 +623 8 +624 9 +625 11 +626 10 +627 12 +628 170 +629 172 +630 174 +631 175 +632 176 +633 171 +634 171 +635 173 +636 173 +637 177 +638 177 +639 7 +640 8 +641 9 +642 11 +643 10 +644 12 +645 170 +646 172 +647 174 +648 175 +649 176 +650 171 +651 171 +652 173 +653 173 +654 177 +655 177 +656 7 +657 8 +658 9 +659 11 +660 10 +661 12 +662 205 +663 207 +664 209 +665 211 +666 213 +667 214 +668 214 +669 206 +670 206 +671 208 +672 208 +673 210 +674 210 +675 212 +676 215 +677 215 +678 215 +679 215 +680 7 +681 8 +682 9 +683 11 +684 10 +685 12 +686 19 +687 21 +688 23 +689 23 +690 20 +691 20 +692 22 +693 24 +694 24 +695 24 +696 24 +697 24 +698 24 +699 7 +700 8 +701 9 +702 11 +703 10 +704 12 +705 25 +706 29 +707 27 +708 31 +709 26 +710 30 +711 30 +712 28 +713 28 +714 28 +715 32 +716 32 +717 32 +718 7 +719 8 +720 9 +721 11 +722 10 +723 12 +724 64 +725 66 +726 67 +727 67 +728 69 +729 69 +730 71 +731 65 +732 65 +733 68 +734 68 +735 70 +736 70 +737 72 +738 7 +739 8 +740 9 +741 11 +742 10 +743 12 +744 13 +745 14 +746 14 +747 14 +748 1 +749 2 +750 3 +751 5 +752 4 +753 6 +754 6 +755 7 +756 8 +757 9 +758 11 +759 10 +760 12 +761 185 +762 187 +763 189 +764 191 +765 193 +766 186 +767 186 +768 188 +769 188 +770 190 +771 190 +772 192 +773 192 +774 194 +775 194 +776 194 +777 7 +778 8 +779 9 +780 11 +781 10 +782 12 +783 170 +784 172 +785 174 +786 175 +787 176 +788 171 +789 171 +790 173 +791 173 +792 177 +793 177 +794 7 +795 8 +796 9 +797 11 +798 10 +799 12 +800 19 +801 21 +802 23 +803 23 +804 20 +805 20 +806 22 +807 24 +808 24 +809 24 +810 24 +811 24 +812 24 +813 7 +814 8 +815 9 +816 11 +817 10 +818 12 +819 156 +820 158 +821 160 +822 161 +823 161 +824 157 +825 157 +826 159 +827 159 +828 7 +829 8 +830 9 +831 11 +832 10 +833 12 +834 140 +835 142 +836 143 +837 143 +838 141 +839 141 +840 1 +841 2 +842 3 +843 5 +844 4 +845 6 +846 6 +847 7 +848 8 +849 9 +850 11 +851 10 +852 12 +853 205 +854 207 +855 209 +856 211 +857 213 +858 214 +859 214 +860 206 +861 206 +862 208 +863 208 +864 210 +865 210 +866 212 +867 215 +868 215 +869 215 +870 215 +871 7 +872 33 +873 9 +874 11 +875 10 +876 12 +877 38 +878 42 +879 40 +880 39 +881 43 +882 41 +883 41 +884 41 +885 7 +886 8 +887 9 +888 11 +889 10 +890 12 +891 19 +892 21 +893 23 +894 23 +895 20 +896 20 +897 22 +898 24 +899 24 +900 24 +901 24 +902 24 +903 24 +904 7 +905 33 +906 9 +907 11 +908 10 +909 12 +910 34 +911 36 +912 35 +913 35 +914 37 +915 7 +916 8 +917 9 +918 11 +919 10 +920 12 +921 140 +922 142 +923 143 +924 143 +925 141 +926 141 +927 7 +928 8 +929 9 +930 11 +931 10 +932 12 +933 73 +934 75 +935 76 +936 76 +937 78 +938 78 +939 80 +940 81 +941 74 +942 74 +943 77 +944 77 +945 79 +946 79 +947 82 +948 7 +949 8 +950 9 +951 11 +952 10 +953 12 +954 150 +955 152 +956 153 +957 154 +958 151 +959 151 +960 155 +961 155 +962 7 +963 8 +964 9 +965 11 +966 10 +967 12 +968 25 +969 29 +970 27 +971 31 +972 26 +973 30 +974 30 +975 28 +976 28 +977 28 +978 32 +979 32 +980 32 +981 7 +982 8 +983 9 +984 11 +985 10 +986 12 +987 170 +988 172 +989 174 +990 175 +991 176 +992 171 +993 171 +994 173 +995 173 +996 177 +997 177 +998 7 +999 8 +1000 9 +1001 11 +1002 10 +1003 12 +1004 185 +1005 187 +1006 189 +1007 191 +1008 193 +1009 186 +1010 186 +1011 188 +1012 188 +1013 190 +1014 190 +1015 192 +1016 192 +1017 194 +1018 194 +1019 194 +1020 7 +1021 8 +1022 9 +1023 11 +1024 10 +1025 12 +1026 156 +1027 158 +1028 160 +1029 161 +1030 161 +1031 157 +1032 157 +1033 159 +1034 159 +1035 7 +1036 33 +1037 9 +1038 11 +1039 10 +1040 12 +1041 34 +1042 36 +1043 35 +1044 35 +1045 37 +1046 7 +1047 33 +1048 9 +1049 11 +1050 10 +1051 12 +1052 38 +1053 42 +1054 40 +1055 39 +1056 43 +1057 41 +1058 41 +1059 41 +1060 7 +1061 8 +1062 9 +1063 11 +1064 10 +1065 12 +1066 19 +1067 21 +1068 23 +1069 23 +1070 20 +1071 20 +1072 22 +1073 24 +1074 24 +1075 24 +1076 24 +1077 24 +1078 24 +1079 7 +1080 8 +1081 9 +1082 11 +1083 10 +1084 12 +1085 109 +1086 111 +1087 112 +1088 114 +1089 116 +1090 118 +1091 110 +1092 110 +1093 113 +1094 115 +1095 117 +1096 119 +1097 7 +1098 8 +1099 9 +1100 11 +1101 10 +1102 12 +1103 19 +1104 21 +1105 23 +1106 23 +1107 20 +1108 20 +1109 22 +1110 24 +1111 24 +1112 24 +1113 24 +1114 24 +1115 24 +1116 7 +1117 8 +1118 9 +1119 11 +1120 10 +1121 12 +1122 15 +1123 17 +1124 17 +1125 16 +1126 18 +1127 18 +1128 18 +1129 18 +1130 18 +1131 18 +1132 7 +1133 8 +1134 9 +1135 11 +1136 10 +1137 12 +1138 19 +1139 21 +1140 23 +1141 23 +1142 20 +1143 20 +1144 22 +1145 24 +1146 24 +1147 24 +1148 24 +1149 24 +1150 24 +1151 7 +1152 8 +1153 9 +1154 11 +1155 10 +1156 12 +1157 205 +1158 207 +1159 209 +1160 211 +1161 213 +1162 214 +1163 214 +1164 206 +1165 206 +1166 208 +1167 208 +1168 210 +1169 210 +1170 212 +1171 215 +1172 215 +1173 215 +1174 215 +1175 7 +1176 8 +1177 9 +1178 11 +1179 10 +1180 12 +1181 19 +1182 21 +1183 23 +1184 23 +1185 20 +1186 20 +1187 22 +1188 24 +1189 24 +1190 24 +1191 24 +1192 24 +1193 24 +1194 7 +1195 8 +1196 9 +1197 11 +1198 10 +1199 12 +1200 205 +1201 207 +1202 209 +1203 211 +1204 213 +1205 214 +1206 214 +1207 206 +1208 206 +1209 208 +1210 208 +1211 210 +1212 210 +1213 212 +1214 215 +1215 215 +1216 215 +1217 215 +1218 1 +1219 2 +1220 3 +1221 5 +1222 4 +1223 6 +1224 6 +1225 1 +1226 2 +1227 238 +1228 239 +1229 4 +1230 6 +1231 6 +1232 239 +1233 402 +1234 403 +1235 403 +1236 402 +1237 403 +1238 403 +1239 402 +1240 403 +1241 403 +1242 402 +1243 403 +1244 403 +1245 402 +1246 403 +1247 403 +1248 402 +1249 403 +1250 403 +1251 402 +1252 403 +1253 403 +1254 402 +1255 403 +1256 403 +1257 402 +1258 403 +1259 403 +1260 402 +1261 403 +1262 403 +1263 402 +1264 403 +1265 403 +1266 402 +1267 403 +1268 403 +1269 402 +1270 403 +1271 403 +1272 402 +1273 403 +1274 403 +1275 402 +1276 403 +1277 403 +1278 402 +1279 403 +1280 403 +1281 402 +1282 403 +1283 403 +1284 402 +1285 403 +1286 403 +1287 402 +1288 403 +1289 403 +1290 402 +1291 403 +1292 403 +1293 402 +1294 403 +1295 403 +1296 402 +1297 403 +1298 403 +1299 402 +1300 403 +1301 403 +1302 402 +1303 403 +1304 403 +1305 402 +1306 403 +1307 403 +1308 402 +1309 403 +1310 403 +1311 402 +1312 403 +1313 403 +1314 402 +1315 403 +1316 403 +1317 402 +1318 403 +1319 403 +1320 402 +1321 403 +1322 403 +1323 402 +1324 403 +1325 403 +1326 402 +1327 403 +1328 403 +1329 402 +1330 403 +1331 403 +1332 402 +1333 403 +1334 403 +1335 402 +1336 403 +1337 403 +1338 402 +1339 403 +1340 403 +1341 402 +1342 403 +1343 403 +1344 402 +1345 403 +1346 403 +1347 402 +1348 403 +1349 403 +1350 402 +1351 403 +1352 403 +1353 402 +1354 403 +1355 403 +1356 402 +1357 403 +1358 403 +1359 402 +1360 403 +1361 403 +1362 402 +1363 403 +1364 403 +1365 402 +1366 403 +1367 403 +1368 402 +1369 403 +1370 403 +1371 402 +1372 403 +1373 403 +1374 402 +1375 403 +1376 403 +1377 402 +1378 403 +1379 403 +1380 402 +1381 403 +1382 403 +1383 402 +1384 403 +1385 403 +1386 402 +1387 403 +1388 403 +1389 402 +1390 403 +1391 403 +1392 402 +1393 403 +1394 403 +1395 402 +1396 403 +1397 403 +1398 402 +1399 403 +1400 403 +1401 402 +1402 403 +1403 403 +1404 402 +1405 403 +1406 403 +1407 402 +1408 403 +1409 403 +1410 402 +1411 403 +1412 403 +1413 402 +1414 403 +1415 403 +1416 402 +1417 403 +1418 403 +1419 402 +1420 403 +1421 403 +1422 402 +1423 403 +1424 403 +1425 402 +1426 403 +1427 403 +1428 402 +1429 403 +1430 403 +1431 402 +1432 403 +1433 403 +1434 402 +1435 403 +1436 403 +1437 402 +1438 403 +1439 403 +1440 402 +1441 403 +1442 403 +1443 402 +1444 403 +1445 403 +1446 402 +1447 403 +1448 403 +1449 402 +1450 403 +1451 403 +1452 402 +1453 403 +1454 403 +1455 402 +1456 403 +1457 403 +1458 402 +1459 403 +1460 403 +1461 402 +1462 403 +1463 403 +1464 402 +1465 403 +1466 403 +1467 402 +1468 403 +1469 403 +1470 402 +1471 403 +1472 403 +1473 402 +1474 403 +1475 403 +1476 402 +1477 403 +1478 403 +1479 402 +1480 403 +1481 403 +1482 402 +1483 403 +1484 403 +1485 402 +1486 403 +1487 403 +1488 402 +1489 403 +1490 403 +1491 402 +1492 403 +1493 403 +1494 402 +1495 403 +1496 403 +1497 402 +1498 403 +1499 403 +1500 402 +1501 403 +1502 403 +1503 402 +1504 403 +1505 403 +1506 402 +1507 403 +1508 403 +1509 402 +1510 403 +1511 403 +1512 402 +1513 403 +1514 403 +1515 402 +1516 403 +1517 403 +1518 402 +1519 403 +1520 403 +1521 402 +1522 403 +1523 403 +1524 402 +1525 403 +1526 403 +1527 402 +1528 403 +1529 403 +1530 402 +1531 403 +1532 403 +1533 402 +1534 403 +1535 403 +1536 402 +1537 403 +1538 403 +1539 402 +1540 403 +1541 403 +1542 402 +1543 403 +1544 403 +1545 402 +1546 403 +1547 403 +1548 402 +1549 403 +1550 403 +1551 402 +1552 403 +1553 403 +1554 402 +1555 403 +1556 403 +1557 402 +1558 403 +1559 403 +1560 402 +1561 403 +1562 403 +1563 402 +1564 403 +1565 403 +1566 402 +1567 403 +1568 403 +1569 402 +1570 403 +1571 403 +1572 402 +1573 403 +1574 403 +1575 402 +1576 403 +1577 403 +1578 402 +1579 403 +1580 403 +1581 402 +1582 403 +1583 403 +1584 402 +1585 403 +1586 403 +1587 402 +1588 403 +1589 403 +1590 402 +1591 403 +1592 403 +1593 402 +1594 403 +1595 403 +1596 402 +1597 403 +1598 403 +1599 402 +1600 403 +1601 403 +1602 402 +1603 403 +1604 403 +1605 402 +1606 403 +1607 403 +1608 402 +1609 403 +1610 403 +1611 402 +1612 403 +1613 403 +1614 402 +1615 403 +1616 403 +1617 402 +1618 403 +1619 403 +1620 402 +1621 403 +1622 403 +1623 402 +1624 403 +1625 403 +1626 402 +1627 403 +1628 403 +1629 402 +1630 403 +1631 403 +1632 402 +1633 403 +1634 403 +1635 402 +1636 403 +1637 403 +1638 402 +1639 403 +1640 403 +1641 402 +1642 403 +1643 403 +1644 402 +1645 403 +1646 403 +1647 402 +1648 403 +1649 403 +1650 402 +1651 403 +1652 403 +1653 402 +1654 403 +1655 403 +1656 402 +1657 403 +1658 403 +1659 402 +1660 403 +1661 403 +1662 402 +1663 403 +1664 403 +1665 402 +1666 403 +1667 403 +1668 402 +1669 403 +1670 403 +1671 402 +1672 403 +1673 403 +1674 402 +1675 403 +1676 403 +1677 402 +1678 403 +1679 403 +1680 402 +1681 403 +1682 403 +1683 402 +1684 403 +1685 403 +1686 402 +1687 403 +1688 403 +1689 402 +1690 403 +1691 403 +1692 402 +1693 403 +1694 403 +1695 402 +1696 403 +1697 403 +1698 402 +1699 403 +1700 403 +1701 402 +1702 403 +1703 403 +1704 402 +1705 403 +1706 403 +1707 402 +1708 403 +1709 403 +1710 402 +1711 403 +1712 403 +1713 402 +1714 403 +1715 403 +1716 402 +1717 403 +1718 403 +1719 402 +1720 403 +1721 403 +1722 402 +1723 403 +1724 403 +1725 402 +1726 403 +1727 403 +1728 402 +1729 403 +1730 403 +1731 402 +1732 403 +1733 403 +1734 402 +1735 403 +1736 403 +1737 402 +1738 403 +1739 403 +1740 402 +1741 403 +1742 403 +1743 402 +1744 403 +1745 403 +1746 402 +1747 403 +1748 403 +1749 402 +1750 403 +1751 403 +1752 402 +1753 403 +1754 403 +1755 402 +1756 403 +1757 403 +1758 402 +1759 403 +1760 403 +1761 402 +1762 403 +1763 403 +1764 402 +1765 403 +1766 403 +1767 402 +1768 403 +1769 403 +1770 402 +1771 403 +1772 403 +1773 402 +1774 403 +1775 403 +1776 402 +1777 403 +1778 403 +1779 402 +1780 403 +1781 403 +1782 402 +1783 403 +1784 403 +1785 402 +1786 403 +1787 403 +1788 402 +1789 403 +1790 403 +1791 402 +1792 403 +1793 403 +1794 402 +1795 403 +1796 403 +1797 402 +1798 403 +1799 403 +1800 402 +1801 403 +1802 403 +1803 402 +1804 403 +1805 403 +1806 402 +1807 403 +1808 403 +1809 402 +1810 403 +1811 403 +1812 402 +1813 403 +1814 403 +1815 402 +1816 403 +1817 403 +1818 402 +1819 403 +1820 403 +1821 402 +1822 403 +1823 403 +1824 402 +1825 403 +1826 403 +1827 402 +1828 403 +1829 403 +1830 402 +1831 403 +1832 403 +1833 402 +1834 403 +1835 403 +1836 402 +1837 403 +1838 403 +1839 402 +1840 403 +1841 403 +1842 402 +1843 403 +1844 403 +1845 402 +1846 403 +1847 403 +1848 402 +1849 403 +1850 403 +1851 402 +1852 403 +1853 403 +1854 402 +1855 403 +1856 403 +1857 402 +1858 403 +1859 403 +1860 402 +1861 403 +1862 403 +1863 402 +1864 403 +1865 403 +1866 402 +1867 403 +1868 403 +1869 402 +1870 403 +1871 403 +1872 402 +1873 403 +1874 403 +1875 402 +1876 403 +1877 403 +1878 402 +1879 403 +1880 403 +1881 402 +1882 403 +1883 403 +1884 402 +1885 403 +1886 403 +1887 402 +1888 403 +1889 403 +1890 402 +1891 403 +1892 403 +1893 402 +1894 403 +1895 403 +1896 402 +1897 403 +1898 403 +1899 402 +1900 403 +1901 403 +1902 402 +1903 403 +1904 403 +1905 402 +1906 403 +1907 403 +1908 402 +1909 403 +1910 403 +1911 402 +1912 403 +1913 403 +1914 402 +1915 403 +1916 403 +1917 402 +1918 403 +1919 403 +1920 402 +1921 403 +1922 403 +1923 402 +1924 403 +1925 403 +1926 402 +1927 403 +1928 403 +1929 402 +1930 403 +1931 403 +1932 402 +1933 403 +1934 403 +1935 402 +1936 403 +1937 403 +1938 402 +1939 403 +1940 403 +1941 402 +1942 403 +1943 403 +1944 402 +1945 403 +1946 403 +1947 402 +1948 403 +1949 403 +1950 402 +1951 403 +1952 403 +1953 402 +1954 403 +1955 403 +1956 402 +1957 403 +1958 403 +1959 402 +1960 403 +1961 403 +1962 402 +1963 403 +1964 403 +1965 402 +1966 403 +1967 403 +1968 402 +1969 403 +1970 403 +1971 402 +1972 403 +1973 403 +1974 402 +1975 403 +1976 403 +1977 402 +1978 403 +1979 403 +1980 402 +1981 403 +1982 403 +1983 402 +1984 403 +1985 403 +1986 402 +1987 403 +1988 403 +1989 402 +1990 403 +1991 403 +1992 402 +1993 403 +1994 403 +1995 402 +1996 403 +1997 403 +1998 402 +1999 403 +2000 403 +2001 402 +2002 403 +2003 403 +2004 402 +2005 403 +2006 403 +2007 402 +2008 403 +2009 403 +2010 402 +2011 403 +2012 403 +2013 402 +2014 403 +2015 403 +2016 402 +2017 403 +2018 403 +2019 402 +2020 403 +2021 403 +2022 402 +2023 403 +2024 403 +2025 402 +2026 403 +2027 403 +2028 402 +2029 403 +2030 403 +2031 402 +2032 403 +2033 403 +2034 402 +2035 403 +2036 403 +2037 402 +2038 403 +2039 403 +2040 402 +2041 403 +2042 403 +2043 402 +2044 403 +2045 403 +2046 402 +2047 403 +2048 403 +2049 402 +2050 403 +2051 403 +2052 402 +2053 403 +2054 403 +2055 402 +2056 403 +2057 403 +2058 402 +2059 403 +2060 403 +2061 402 +2062 403 +2063 403 +2064 402 +2065 403 +2066 403 +2067 402 +2068 403 +2069 403 +2070 402 +2071 403 +2072 403 +2073 402 +2074 403 +2075 403 +2076 402 +2077 403 +2078 403 +2079 402 +2080 403 +2081 403 +2082 402 +2083 403 +2084 403 +2085 402 +2086 403 +2087 403 +2088 402 +2089 403 +2090 403 +2091 402 +2092 403 +2093 403 +2094 402 +2095 403 +2096 403 +2097 402 +2098 403 +2099 403 +2100 402 +2101 403 +2102 403 +2103 402 +2104 403 +2105 403 +2106 402 +2107 403 +2108 403 +2109 402 +2110 403 +2111 403 +2112 402 +2113 403 +2114 403 +2115 402 +2116 403 +2117 403 +2118 402 +2119 403 +2120 403 +2121 402 +2122 403 +2123 403 +2124 402 +2125 403 +2126 403 +2127 402 +2128 403 +2129 403 +2130 402 +2131 403 +2132 403 +2133 402 +2134 403 +2135 403 +2136 402 +2137 403 +2138 403 +2139 402 +2140 403 +2141 403 +2142 402 +2143 403 +2144 403 +2145 402 +2146 403 +2147 403 +2148 402 +2149 403 +2150 403 +2151 402 +2152 403 +2153 403 +2154 402 +2155 403 +2156 403 +2157 402 +2158 403 +2159 403 +2160 402 +2161 403 +2162 403 +2163 402 +2164 403 +2165 403 +2166 402 +2167 403 +2168 403 +2169 402 +2170 403 +2171 403 +2172 402 +2173 403 +2174 403 +2175 402 +2176 403 +2177 403 +2178 402 +2179 403 +2180 403 +2181 402 +2182 403 +2183 403 +2184 402 +2185 403 +2186 403 +2187 402 +2188 403 +2189 403 +2190 402 +2191 403 +2192 403 +2193 402 +2194 403 +2195 403 +2196 402 +2197 403 +2198 403 +2199 402 +2200 403 +2201 403 +2202 402 +2203 403 +2204 403 +2205 402 +2206 403 +2207 403 +2208 402 +2209 403 +2210 403 +2211 402 +2212 403 +2213 403 +2214 402 +2215 403 +2216 403 +2217 402 +2218 403 +2219 403 +2220 402 +2221 403 +2222 403 +2223 402 +2224 403 +2225 403 +2226 402 +2227 403 +2228 403 +2229 402 +2230 403 +2231 403 +2232 402 +2233 403 +2234 403 +2235 402 +2236 403 +2237 403 +2238 402 +2239 403 +2240 403 +2241 402 +2242 403 +2243 403 +2244 402 +2245 403 +2246 403 +2247 402 +2248 403 +2249 403 +2250 402 +2251 403 +2252 403 +2253 402 +2254 403 +2255 403 +2256 402 +2257 403 +2258 403 +2259 402 +2260 403 +2261 403 +2262 402 +2263 403 +2264 403 +2265 402 +2266 403 +2267 403 +2268 402 +2269 403 +2270 403 +2271 402 +2272 403 +2273 403 +2274 402 +2275 403 +2276 403 +2277 402 +2278 403 +2279 403 +2280 402 +2281 403 +2282 403 +2283 402 +2284 403 +2285 403 +2286 402 +2287 403 +2288 403 +2289 402 +2290 403 +2291 403 +2292 402 +2293 403 +2294 403 +2295 402 +2296 403 +2297 403 +2298 402 +2299 403 +2300 403 +2301 402 +2302 403 +2303 403 +2304 402 +2305 403 +2306 403 +2307 402 +2308 403 +2309 403 +2310 402 +2311 403 +2312 403 +2313 402 +2314 403 +2315 403 +2316 402 +2317 403 +2318 403 +2319 402 +2320 403 +2321 403 +2322 402 +2323 403 +2324 403 +2325 402 +2326 403 +2327 403 +2328 402 +2329 403 +2330 403 +2331 402 +2332 403 +2333 403 +2334 402 +2335 403 +2336 403 +2337 402 +2338 403 +2339 403 +2340 402 +2341 403 +2342 403 +2343 402 +2344 403 +2345 403 +2346 402 +2347 403 +2348 403 +2349 402 +2350 403 +2351 403 +2352 402 +2353 403 +2354 403 +2355 402 +2356 403 +2357 403 +2358 402 +2359 403 +2360 403 +2361 402 +2362 403 +2363 403 +2364 402 +2365 403 +2366 403 +2367 402 +2368 403 +2369 403 +2370 402 +2371 403 +2372 403 +2373 402 +2374 403 +2375 403 +2376 402 +2377 403 +2378 403 +2379 402 +2380 403 +2381 403 +2382 402 +2383 403 +2384 403 +2385 402 +2386 403 +2387 403 +2388 402 +2389 403 +2390 403 +2391 402 +2392 403 +2393 403 +2394 402 +2395 403 +2396 403 +2397 402 +2398 403 +2399 403 +2400 402 +2401 403 +2402 403 +2403 402 +2404 403 +2405 403 +2406 402 +2407 403 +2408 403 +2409 402 +2410 403 +2411 403 +2412 402 +2413 403 +2414 403 +2415 402 +2416 403 +2417 403 +2418 402 +2419 403 +2420 403 +2421 402 +2422 403 +2423 403 +2424 402 +2425 403 +2426 403 +2427 402 +2428 403 +2429 403 +2430 402 +2431 403 +2432 403 +2433 402 +2434 403 +2435 403 +2436 402 +2437 403 +2438 403 +2439 402 +2440 403 +2441 403 +2442 402 +2443 403 +2444 403 +2445 402 +2446 403 +2447 403 +2448 402 +2449 403 +2450 403 +2451 402 +2452 403 +2453 403 +2454 402 +2455 403 +2456 403 +2457 402 +2458 403 +2459 403 +2460 402 +2461 403 +2462 403 +2463 402 +2464 403 +2465 403 +2466 402 +2467 403 +2468 403 +2469 402 +2470 403 +2471 403 +2472 402 +2473 403 +2474 403 +2475 402 +2476 403 +2477 403 +2478 402 +2479 403 +2480 403 +2481 402 +2482 403 +2483 403 +2484 402 +2485 403 +2486 403 +2487 402 +2488 403 +2489 403 +2490 402 +2491 403 +2492 403 +2493 402 +2494 403 +2495 403 +2496 402 +2497 403 +2498 403 +2499 402 +2500 403 +2501 403 +2502 402 +2503 403 +2504 403 +2505 402 +2506 403 +2507 403 +2508 402 +2509 403 +2510 403 +2511 402 +2512 403 +2513 403 +2514 402 +2515 403 +2516 403 +2517 402 +2518 403 +2519 403 +2520 402 +2521 403 +2522 403 +2523 402 +2524 403 +2525 403 +2526 402 +2527 403 +2528 403 +2529 402 +2530 403 +2531 403 +2532 402 +2533 403 +2534 403 +2535 402 +2536 403 +2537 403 +2538 402 +2539 403 +2540 403 +2541 402 +2542 403 +2543 403 +2544 402 +2545 403 +2546 403 +2547 402 +2548 403 +2549 403 +2550 402 +2551 403 +2552 403 +2553 402 +2554 403 +2555 403 +2556 402 +2557 403 +2558 403 +2559 402 +2560 403 +2561 403 +2562 402 +2563 403 +2564 403 +2565 402 +2566 403 +2567 403 +2568 402 +2569 403 +2570 403 +2571 402 +2572 403 +2573 403 +2574 402 +2575 403 +2576 403 +2577 402 +2578 403 +2579 403 +2580 402 +2581 403 +2582 403 +2583 402 +2584 403 +2585 403 +2586 402 +2587 403 +2588 403 +2589 402 +2590 403 +2591 403 +2592 402 +2593 403 +2594 403 +2595 402 +2596 403 +2597 403 +2598 402 +2599 403 +2600 403 +2601 402 +2602 403 +2603 403 +2604 402 +2605 403 +2606 403 +2607 402 +2608 403 +2609 403 +2610 402 +2611 403 +2612 403 +2613 402 +2614 403 +2615 403 +2616 402 +2617 403 +2618 403 +2619 402 +2620 403 +2621 403 +2622 402 +2623 403 +2624 403 +2625 402 +2626 403 +2627 403 +2628 402 +2629 403 +2630 403 +2631 402 +2632 403 +2633 403 +2634 402 +2635 403 +2636 403 +2637 402 +2638 403 +2639 403 +2640 402 +2641 403 +2642 403 +2643 402 +2644 403 +2645 403 +2646 402 +2647 403 +2648 403 +2649 402 +2650 403 +2651 403 +2652 402 +2653 403 +2654 403 +2655 402 +2656 403 +2657 403 +2658 402 +2659 403 +2660 403 +2661 402 +2662 403 +2663 403 +2664 402 +2665 403 +2666 403 +2667 402 +2668 403 +2669 403 +2670 402 +2671 403 +2672 403 +2673 402 +2674 403 +2675 403 +2676 402 +2677 403 +2678 403 +2679 402 +2680 403 +2681 403 +2682 402 +2683 403 +2684 403 +2685 402 +2686 403 +2687 403 +2688 402 +2689 403 +2690 403 +2691 402 +2692 403 +2693 403 +2694 402 +2695 403 +2696 403 +2697 402 +2698 403 +2699 403 +2700 402 +2701 403 +2702 403 +2703 402 +2704 403 +2705 403 +2706 402 +2707 403 +2708 403 +2709 402 +2710 403 +2711 403 +2712 402 +2713 403 +2714 403 +2715 402 +2716 403 +2717 403 +2718 402 +2719 403 +2720 403 +2721 402 +2722 403 +2723 403 +2724 402 +2725 403 +2726 403 +2727 402 +2728 403 +2729 403 +2730 402 +2731 403 +2732 403 +2733 402 +2734 403 +2735 403 +2736 402 +2737 403 +2738 403 +2739 402 +2740 403 +2741 403 +2742 402 +2743 403 +2744 403 +2745 402 +2746 403 +2747 403 +2748 402 +2749 403 +2750 403 +2751 402 +2752 403 +2753 403 +2754 402 +2755 403 +2756 403 +2757 402 +2758 403 +2759 403 +2760 402 +2761 403 +2762 403 +2763 402 +2764 403 +2765 403 +2766 402 +2767 403 +2768 403 +2769 402 +2770 403 +2771 403 +2772 402 +2773 403 +2774 403 +2775 402 +2776 403 +2777 403 +2778 402 +2779 403 +2780 403 +2781 402 +2782 403 +2783 403 +2784 402 +2785 403 +2786 403 +2787 402 +2788 403 +2789 403 +2790 402 +2791 403 +2792 403 +2793 402 +2794 403 +2795 403 +2796 402 +2797 403 +2798 403 +2799 402 +2800 403 +2801 403 +2802 402 +2803 403 +2804 403 +2805 402 +2806 403 +2807 403 +2808 402 +2809 403 +2810 403 +2811 402 +2812 403 +2813 403 +2814 402 +2815 403 +2816 403 +2817 402 +2818 403 +2819 403 +2820 402 +2821 403 +2822 403 +2823 402 +2824 403 +2825 403 +2826 402 +2827 403 +2828 403 +2829 402 +2830 403 +2831 403 +2832 402 +2833 403 +2834 403 +2835 402 +2836 403 +2837 403 +2838 402 +2839 403 +2840 403 +2841 402 +2842 403 +2843 403 +2844 402 +2845 403 +2846 403 +2847 402 +2848 403 +2849 403 +2850 402 +2851 403 +2852 403 +2853 402 +2854 403 +2855 403 +2856 402 +2857 403 +2858 403 +2859 402 +2860 403 +2861 403 +2862 402 +2863 403 +2864 403 +2865 402 +2866 403 +2867 403 +2868 402 +2869 403 +2870 403 +2871 402 +2872 403 +2873 403 +2874 402 +2875 403 +2876 403 +2877 402 +2878 403 +2879 403 +2880 402 +2881 403 +2882 403 +2883 402 +2884 403 +2885 403 +2886 402 +2887 403 +2888 403 +2889 402 +2890 403 +2891 403 +2892 402 +2893 403 +2894 403 +2895 402 +2896 403 +2897 403 +2898 402 +2899 403 +2900 403 +2901 402 +2902 403 +2903 403 +2904 402 +2905 403 +2906 403 +2907 402 +2908 403 +2909 403 +2910 402 +2911 403 +2912 403 +2913 402 +2914 403 +2915 403 +2916 402 +2917 403 +2918 403 +2919 402 +2920 403 +2921 403 +2922 402 +2923 403 +2924 403 +2925 402 +2926 403 +2927 403 +2928 402 +2929 403 +2930 403 +2931 402 +2932 403 +2933 403 +2934 402 +2935 403 +2936 403 +2937 402 +2938 403 +2939 403 +2940 402 +2941 403 +2942 403 +2943 402 +2944 403 +2945 403 +2946 402 +2947 403 +2948 403 +2949 402 +2950 403 +2951 403 +2952 402 +2953 403 +2954 403 +2955 402 +2956 403 +2957 403 +2958 402 +2959 403 +2960 403 +2961 402 +2962 403 +2963 403 +2964 402 +2965 403 +2966 403 +2967 402 +2968 403 +2969 403 +2970 402 +2971 403 +2972 403 +2973 402 +2974 403 +2975 403 +2976 402 +2977 403 +2978 403 +2979 402 +2980 403 +2981 403 +2982 402 +2983 403 +2984 403 +2985 402 +2986 403 +2987 403 +2988 402 +2989 403 +2990 403 +2991 402 +2992 403 +2993 403 +2994 402 +2995 403 +2996 403 +2997 402 +2998 403 +2999 403 +3000 402 +3001 403 +3002 403 +3003 402 +3004 403 +3005 403 +3006 402 +3007 403 +3008 403 +3009 402 +3010 403 +3011 403 +3012 402 +3013 403 +3014 403 +3015 402 +3016 403 +3017 403 +3018 402 +3019 403 +3020 403 +3021 402 +3022 403 +3023 403 +3024 402 +3025 403 +3026 403 +3027 402 +3028 403 +3029 403 +3030 402 +3031 403 +3032 403 +3033 402 +3034 403 +3035 403 +3036 402 +3037 403 +3038 403 +3039 402 +3040 403 +3041 403 +3042 402 +3043 403 +3044 403 +3045 402 +3046 403 +3047 403 +3048 402 +3049 403 +3050 403 +3051 402 +3052 403 +3053 403 +3054 402 +3055 403 +3056 403 +3057 402 +3058 403 +3059 403 +3060 402 +3061 403 +3062 403 +3063 402 +3064 403 +3065 403 +3066 402 +3067 403 +3068 403 +3069 402 +3070 403 +3071 403 +3072 402 +3073 403 +3074 403 +3075 402 +3076 403 +3077 403 +3078 402 +3079 403 +3080 403 +3081 402 +3082 403 +3083 403 +3084 402 +3085 403 +3086 403 +3087 402 +3088 403 +3089 403 +3090 402 +3091 403 +3092 403 +3093 402 +3094 403 +3095 403 +3096 402 +3097 403 +3098 403 +3099 402 +3100 403 +3101 403 +3102 402 +3103 403 +3104 403 +3105 402 +3106 403 +3107 403 +3108 402 +3109 403 +3110 403 +3111 402 +3112 403 +3113 403 +3114 402 +3115 403 +3116 403 +3117 402 +3118 403 +3119 403 +3120 402 +3121 403 +3122 403 +3123 402 +3124 403 +3125 403 +3126 402 +3127 403 +3128 403 +3129 402 +3130 403 +3131 403 +3132 402 +3133 403 +3134 403 +3135 402 +3136 403 +3137 403 +3138 402 +3139 403 +3140 403 +3141 402 +3142 403 +3143 403 +3144 402 +3145 403 +3146 403 +3147 402 +3148 403 +3149 403 +3150 402 +3151 403 +3152 403 +3153 402 +3154 403 +3155 403 +3156 402 +3157 403 +3158 403 +3159 402 +3160 403 +3161 403 +3162 402 +3163 403 +3164 403 +3165 402 +3166 403 +3167 403 +3168 402 +3169 403 +3170 403 +3171 402 +3172 403 +3173 403 +3174 402 +3175 403 +3176 403 +3177 402 +3178 403 +3179 403 +3180 402 +3181 403 +3182 403 +3183 402 +3184 403 +3185 403 +3186 402 +3187 403 +3188 403 +3189 402 +3190 403 +3191 403 +3192 402 +3193 403 +3194 403 +3195 402 +3196 403 +3197 403 +3198 402 +3199 403 +3200 403 +3201 402 +3202 403 +3203 403 +3204 402 +3205 403 +3206 403 +3207 402 +3208 403 +3209 403 +3210 402 +3211 403 +3212 403 +3213 402 +3214 403 +3215 403 +3216 402 +3217 403 +3218 403 +3219 402 +3220 403 +3221 403 +3222 402 +3223 403 +3224 403 +3225 402 +3226 403 +3227 403 +3228 402 +3229 403 +3230 403 +3231 402 +3232 403 +3233 403 +3234 402 +3235 403 +3236 403 +3237 402 +3238 403 +3239 403 +3240 402 +3241 403 +3242 403 +3243 402 +3244 403 +3245 403 +3246 402 +3247 403 +3248 403 +3249 402 +3250 403 +3251 403 +3252 402 +3253 403 +3254 403 +3255 402 +3256 403 +3257 403 +3258 402 +3259 403 +3260 403 +3261 402 +3262 403 +3263 403 +3264 402 +3265 403 +3266 403 +3267 402 +3268 403 +3269 403 +3270 402 +3271 403 +3272 403 +3273 402 +3274 403 +3275 403 +3276 402 +3277 403 +3278 403 +3279 402 +3280 403 +3281 403 +3282 402 +3283 403 +3284 403 +3285 402 +3286 403 +3287 403 +3288 402 +3289 403 +3290 403 +3291 402 +3292 403 +3293 403 +3294 402 +3295 403 +3296 403 +3297 402 +3298 403 +3299 403 +3300 402 +3301 403 +3302 403 +3303 402 +3304 403 +3305 403 +3306 402 +3307 403 +3308 403 +3309 402 +3310 403 +3311 403 +3312 402 +3313 403 +3314 403 +3315 402 +3316 403 +3317 403 +3318 402 +3319 403 +3320 403 +3321 402 +3322 403 +3323 403 +3324 402 +3325 403 +3326 403 +3327 402 +3328 403 +3329 403 +3330 402 +3331 403 +3332 403 +3333 402 +3334 403 +3335 403 +3336 402 +3337 403 +3338 403 +3339 402 +3340 403 +3341 403 +3342 402 +3343 403 +3344 403 +3345 402 +3346 403 +3347 403 +3348 402 +3349 403 +3350 403 +3351 402 +3352 403 +3353 403 +3354 402 +3355 403 +3356 403 +3357 402 +3358 403 +3359 403 +3360 402 +3361 403 +3362 403 +3363 402 +3364 403 +3365 403 +3366 402 +3367 403 +3368 403 +3369 402 +3370 403 +3371 403 +3372 402 +3373 403 +3374 403 +3375 402 +3376 403 +3377 403 +3378 402 +3379 403 +3380 403 +3381 402 +3382 403 +3383 403 +3384 402 +3385 403 +3386 403 +3387 402 +3388 403 +3389 403 +3390 402 +3391 403 +3392 403 +3393 402 +3394 403 +3395 403 +3396 402 +3397 403 +3398 403 +3399 402 +3400 403 +3401 403 +3402 402 +3403 403 +3404 403 +3405 402 +3406 403 +3407 403 +3408 402 +3409 403 +3410 403 +3411 402 +3412 403 +3413 403 +3414 402 +3415 403 +3416 403 +3417 402 +3418 403 +3419 403 +3420 402 +3421 403 +3422 403 +3423 402 +3424 403 +3425 403 +3426 402 +3427 403 +3428 403 +3429 402 +3430 403 +3431 403 +3432 402 +3433 403 +3434 403 +3435 402 +3436 403 +3437 403 +3438 402 +3439 403 +3440 403 +3441 402 +3442 403 +3443 403 +3444 402 +3445 403 +3446 403 +3447 402 +3448 403 +3449 403 +3450 402 +3451 403 +3452 403 +3453 402 +3454 403 +3455 403 +3456 402 +3457 403 +3458 403 +3459 402 +3460 403 +3461 403 +3462 402 +3463 403 +3464 403 +3465 402 +3466 403 +3467 403 +3468 402 +3469 403 +3470 403 +3471 402 +3472 403 +3473 403 +3474 402 +3475 403 +3476 403 +3477 402 +3478 403 +3479 403 +3480 402 +3481 403 +3482 403 +3483 402 +3484 403 +3485 403 +3486 402 +3487 403 +3488 403 +3489 402 +3490 403 +3491 403 +3492 402 +3493 403 +3494 403 +3495 402 +3496 403 +3497 403 +3498 402 +3499 403 +3500 403 +3501 402 +3502 403 +3503 403 +3504 402 +3505 403 +3506 403 +3507 402 +3508 403 +3509 403 +3510 402 +3511 403 +3512 403 +3513 402 +3514 403 +3515 403 +3516 402 +3517 403 +3518 403 +3519 402 +3520 403 +3521 403 +3522 402 +3523 403 +3524 403 +3525 402 +3526 403 +3527 403 +3528 402 +3529 403 +3530 403 +3531 402 +3532 403 +3533 403 +3534 402 +3535 403 +3536 403 +3537 402 +3538 403 +3539 403 +3540 402 +3541 403 +3542 403 +3543 402 +3544 403 +3545 403 +3546 402 +3547 403 +3548 403 +3549 402 +3550 403 +3551 403 +3552 402 +3553 403 +3554 403 +3555 402 +3556 403 +3557 403 +3558 402 +3559 403 +3560 403 +3561 402 +3562 403 +3563 403 +3564 402 +3565 403 +3566 403 +3567 402 +3568 403 +3569 403 +3570 402 +3571 403 +3572 403 +3573 402 +3574 403 +3575 403 +3576 402 +3577 403 +3578 403 +3579 402 +3580 403 +3581 403 +3582 402 +3583 403 +3584 403 +3585 402 +3586 403 +3587 403 +3588 402 +3589 403 +3590 403 +3591 402 +3592 403 +3593 403 +3594 402 +3595 403 +3596 403 +3597 402 +3598 403 +3599 403 +3600 402 +3601 403 +3602 403 +3603 402 +3604 403 +3605 403 +3606 402 +3607 403 +3608 403 +3609 402 +3610 403 +3611 403 +3612 402 +3613 403 +3614 403 +3615 402 +3616 403 +3617 403 +3618 402 +3619 403 +3620 403 +3621 402 +3622 403 +3623 403 +3624 402 +3625 403 +3626 403 +3627 402 +3628 403 +3629 403 +3630 402 +3631 403 +3632 403 +3633 402 +3634 403 +3635 403 +3636 402 +3637 403 +3638 403 +3639 402 +3640 403 +3641 403 +3642 402 +3643 403 +3644 403 +3645 402 +3646 403 +3647 403 +3648 402 +3649 403 +3650 403 +3651 402 +3652 403 +3653 403 +3654 402 +3655 403 +3656 403 +3657 402 +3658 403 +3659 403 +3660 402 +3661 403 +3662 403 +3663 402 +3664 403 +3665 403 +3666 402 +3667 403 +3668 403 +3669 402 +3670 403 +3671 403 +3672 402 +3673 403 +3674 403 +3675 402 +3676 403 +3677 403 +3678 402 +3679 403 +3680 403 +3681 402 +3682 403 +3683 403 +3684 402 +3685 403 +3686 403 +3687 402 +3688 403 +3689 403 +3690 402 +3691 403 +3692 403 +3693 402 +3694 403 +3695 403 +3696 402 +3697 403 +3698 403 +3699 402 +3700 403 +3701 403 +3702 402 +3703 403 +3704 403 +3705 402 +3706 403 +3707 403 +3708 402 +3709 403 +3710 403 +3711 402 +3712 403 +3713 403 +3714 402 +3715 403 +3716 403 +3717 402 +3718 403 +3719 403 +3720 402 +3721 403 +3722 403 +3723 402 +3724 403 +3725 403 +3726 402 +3727 403 +3728 403 +3729 402 +3730 403 +3731 403 +3732 402 +3733 403 +3734 403 +3735 402 +3736 403 +3737 403 +3738 402 +3739 403 +3740 403 +3741 402 +3742 403 +3743 403 +3744 402 +3745 403 +3746 403 +3747 402 +3748 403 +3749 403 +3750 402 +3751 403 +3752 403 +3753 402 +3754 403 +3755 403 +3756 402 +3757 403 +3758 403 +3759 402 +3760 403 +3761 403 +3762 402 +3763 403 +3764 403 +3765 402 +3766 403 +3767 403 +3768 402 +3769 403 +3770 403 +3771 402 +3772 403 +3773 403 +3774 402 +3775 403 +3776 403 +3777 402 +3778 403 +3779 403 +3780 402 +3781 403 +3782 403 +3783 402 +3784 403 +3785 403 +3786 402 +3787 403 +3788 403 +3789 402 +3790 403 +3791 403 +3792 402 +3793 403 +3794 403 +3795 402 +3796 403 +3797 403 +3798 402 +3799 403 +3800 403 +3801 402 +3802 403 +3803 403 +3804 402 +3805 403 +3806 403 +3807 402 +3808 403 +3809 403 +3810 402 +3811 403 +3812 403 +3813 402 +3814 403 +3815 403 +3816 402 +3817 403 +3818 403 +3819 402 +3820 403 +3821 403 +3822 402 +3823 403 +3824 403 +3825 402 +3826 403 +3827 403 +3828 402 +3829 403 +3830 403 +3831 402 +3832 403 +3833 403 +3834 402 +3835 403 +3836 403 +3837 402 +3838 403 +3839 403 +3840 402 +3841 403 +3842 403 +3843 402 +3844 403 +3845 403 +3846 402 +3847 403 +3848 403 +3849 402 +3850 403 +3851 403 +3852 402 +3853 403 +3854 403 +3855 402 +3856 403 +3857 403 +3858 402 +3859 403 +3860 403 +3861 402 +3862 403 +3863 403 +3864 402 +3865 403 +3866 403 +3867 402 +3868 403 +3869 403 +3870 402 +3871 403 +3872 403 +3873 402 +3874 403 +3875 403 +3876 402 +3877 403 +3878 403 +3879 402 +3880 403 +3881 403 +3882 402 +3883 403 +3884 403 +3885 402 +3886 403 +3887 403 +3888 402 +3889 403 +3890 403 +3891 402 +3892 403 +3893 403 +3894 402 +3895 403 +3896 403 +3897 402 +3898 403 +3899 403 +3900 402 +3901 403 +3902 403 +3903 402 +3904 403 +3905 403 +3906 402 +3907 403 +3908 403 +3909 402 +3910 403 +3911 403 +3912 402 +3913 403 +3914 403 +3915 402 +3916 403 +3917 403 +3918 402 +3919 403 +3920 403 +3921 402 +3922 403 +3923 403 +3924 402 +3925 403 +3926 403 +3927 402 +3928 403 +3929 403 +3930 402 +3931 403 +3932 403 +3933 402 +3934 403 +3935 403 +3936 402 +3937 403 +3938 403 +3939 402 +3940 403 +3941 403 +3942 402 +3943 403 +3944 403 +3945 402 +3946 403 +3947 403 +3948 402 +3949 403 +3950 403 +3951 402 +3952 403 +3953 403 +3954 402 +3955 403 +3956 403 +3957 402 +3958 403 +3959 403 +3960 402 +3961 403 +3962 403 +3963 402 +3964 403 +3965 403 +3966 402 +3967 403 +3968 403 +3969 402 +3970 403 +3971 403 +3972 402 +3973 403 +3974 403 +3975 402 +3976 403 +3977 403 +3978 402 +3979 403 +3980 403 +3981 402 +3982 403 +3983 403 +3984 402 +3985 403 +3986 403 +3987 402 +3988 403 +3989 403 +3990 402 +3991 403 +3992 403 +3993 402 +3994 403 +3995 403 +3996 402 +3997 403 +3998 403 +3999 402 +4000 403 +4001 403 +4002 402 +4003 403 +4004 403 +4005 402 +4006 403 +4007 403 +4008 402 +4009 403 +4010 403 +4011 402 +4012 403 +4013 403 +4014 402 +4015 403 +4016 403 +4017 402 +4018 403 +4019 403 +4020 402 +4021 403 +4022 403 +4023 402 +4024 403 +4025 403 +4026 402 +4027 403 +4028 403 +4029 402 +4030 403 +4031 403 +4032 402 +4033 403 +4034 403 +4035 402 +4036 403 +4037 403 +4038 402 +4039 403 +4040 403 +4041 402 +4042 403 +4043 403 +4044 402 +4045 403 +4046 403 +4047 402 +4048 403 +4049 403 +4050 402 +4051 403 +4052 403 +4053 402 +4054 403 +4055 403 +4056 402 +4057 403 +4058 403 +4059 402 +4060 403 +4061 403 +4062 402 +4063 403 +4064 403 +4065 402 +4066 403 +4067 403 +4068 402 +4069 403 +4070 403 +4071 402 +4072 403 +4073 403 +4074 402 +4075 403 +4076 403 +4077 402 +4078 403 +4079 403 +4080 402 +4081 403 +4082 403 +4083 402 +4084 403 +4085 403 +4086 402 +4087 403 +4088 403 +4089 402 +4090 403 +4091 403 +4092 402 +4093 403 +4094 403 +4095 402 +4096 403 +4097 403 +4098 402 +4099 403 +4100 403 +4101 402 +4102 403 +4103 403 +4104 402 +4105 403 +4106 403 +4107 402 +4108 403 +4109 403 +4110 402 +4111 403 +4112 403 +4113 402 +4114 403 +4115 403 +4116 402 +4117 403 +4118 403 +4119 402 +4120 403 +4121 403 +4122 402 +4123 403 +4124 403 +4125 402 +4126 403 +4127 403 +4128 402 +4129 403 +4130 403 +4131 402 +4132 403 +4133 403 +4134 402 +4135 403 +4136 403 +4137 402 +4138 403 +4139 403 +4140 402 +4141 403 +4142 403 +4143 402 +4144 403 +4145 403 +4146 402 +4147 403 +4148 403 +4149 402 +4150 403 +4151 403 +4152 402 +4153 403 +4154 403 +4155 402 +4156 403 +4157 403 +4158 402 +4159 403 +4160 403 +4161 402 +4162 403 +4163 403 +4164 402 +4165 403 +4166 403 +4167 402 +4168 403 +4169 403 +4170 402 +4171 403 +4172 403 +4173 402 +4174 403 +4175 403 +4176 402 +4177 403 +4178 403 +4179 402 +4180 403 +4181 403 +4182 402 +4183 403 +4184 403 +4185 402 +4186 403 +4187 403 +4188 402 +4189 403 +4190 403 +4191 402 +4192 403 +4193 403 +4194 402 +4195 403 +4196 403 +4197 402 +4198 403 +4199 403 +4200 402 +4201 403 +4202 403 +4203 402 +4204 403 +4205 403 +4206 402 +4207 403 +4208 403 +4209 402 +4210 403 +4211 403 +4212 402 +4213 403 +4214 403 +4215 402 +4216 403 +4217 403 +4218 402 +4219 403 +4220 403 +4221 402 +4222 403 +4223 403 +4224 402 +4225 403 +4226 403 +4227 402 +4228 403 +4229 403 +4230 402 +4231 403 +4232 403 +4233 402 +4234 403 +4235 403 +4236 402 +4237 403 +4238 403 +4239 402 +4240 403 +4241 403 +4242 402 +4243 403 +4244 403 +4245 402 +4246 403 +4247 403 +4248 402 +4249 403 +4250 403 +4251 402 +4252 403 +4253 403 +4254 402 +4255 403 +4256 403 +4257 402 +4258 403 +4259 403 +4260 402 +4261 403 +4262 403 +4263 402 +4264 403 +4265 403 +4266 402 +4267 403 +4268 403 +4269 402 +4270 403 +4271 403 +4272 402 +4273 403 +4274 403 +4275 402 +4276 403 +4277 403 +4278 402 +4279 403 +4280 403 +4281 402 +4282 403 +4283 403 +4284 402 +4285 403 +4286 403 +4287 402 +4288 403 +4289 403 +4290 402 +4291 403 +4292 403 +4293 402 +4294 403 +4295 403 +4296 402 +4297 403 +4298 403 +4299 402 +4300 403 +4301 403 +4302 402 +4303 403 +4304 403 +4305 402 +4306 403 +4307 403 +4308 402 +4309 403 +4310 403 +4311 402 +4312 403 +4313 403 +4314 402 +4315 403 +4316 403 +4317 402 +4318 403 +4319 403 +4320 402 +4321 403 +4322 403 +4323 402 +4324 403 +4325 403 +4326 402 +4327 403 +4328 403 +4329 402 +4330 403 +4331 403 +4332 402 +4333 403 +4334 403 +4335 402 +4336 403 +4337 403 +4338 402 +4339 403 +4340 403 +4341 402 +4342 403 +4343 403 +4344 402 +4345 403 +4346 403 +4347 402 +4348 403 +4349 403 +4350 402 +4351 403 +4352 403 +4353 402 +4354 403 +4355 403 +4356 402 +4357 403 +4358 403 +4359 402 +4360 403 +4361 403 +4362 402 +4363 403 +4364 403 +4365 402 +4366 403 +4367 403 +4368 402 +4369 403 +4370 403 +4371 402 +4372 403 +4373 403 +4374 402 +4375 403 +4376 403 +4377 402 +4378 403 +4379 403 +4380 402 +4381 403 +4382 403 +4383 402 +4384 403 +4385 403 +4386 402 +4387 403 +4388 403 +4389 402 +4390 403 +4391 403 +4392 402 +4393 403 +4394 403 +4395 402 +4396 403 +4397 403 +4398 402 +4399 403 +4400 403 +4401 402 +4402 403 +4403 403 +4404 402 +4405 403 +4406 403 +4407 402 +4408 403 +4409 403 +4410 402 +4411 403 +4412 403 +4413 402 +4414 403 +4415 403 +4416 402 +4417 403 +4418 403 +4419 402 +4420 403 +4421 403 +4422 402 +4423 403 +4424 403 +4425 402 +4426 403 +4427 403 +4428 402 +4429 403 +4430 403 +4431 402 +4432 403 +4433 403 +4434 402 +4435 403 +4436 403 +4437 402 +4438 403 +4439 403 +4440 402 +4441 403 +4442 403 +4443 402 +4444 403 +4445 403 +4446 402 +4447 403 +4448 403 +4449 402 +4450 403 +4451 403 +4452 402 +4453 403 +4454 403 +4455 402 +4456 403 +4457 403 +4458 402 +4459 403 +4460 403 +4461 402 +4462 403 +4463 403 +4464 402 +4465 403 +4466 403 +4467 402 +4468 403 +4469 403 +4470 402 +4471 403 +4472 403 +4473 402 +4474 403 +4475 403 +4476 402 +4477 403 +4478 403 +4479 402 +4480 403 +4481 403 +4482 402 +4483 403 +4484 403 +4485 402 +4486 403 +4487 403 +4488 402 +4489 403 +4490 403 +4491 402 +4492 403 +4493 403 +4494 402 +4495 403 +4496 403 +4497 402 +4498 403 +4499 403 +4500 402 +4501 403 +4502 403 +4503 402 +4504 403 +4505 403 +4506 402 +4507 403 +4508 403 +4509 402 +4510 403 +4511 403 +4512 402 +4513 403 +4514 403 +4515 402 +4516 403 +4517 403 +4518 402 +4519 403 +4520 403 +4521 402 +4522 403 +4523 403 +4524 402 +4525 403 +4526 403 +4527 402 +4528 403 +4529 403 +4530 402 +4531 403 +4532 403 +4533 402 +4534 403 +4535 403 +4536 402 +4537 403 +4538 403 +4539 402 +4540 403 +4541 403 +4542 402 +4543 403 +4544 403 +4545 402 +4546 403 +4547 403 +4548 402 +4549 403 +4550 403 +4551 402 +4552 403 +4553 403 +4554 402 +4555 403 +4556 403 +4557 402 +4558 403 +4559 403 +4560 402 +4561 403 +4562 403 +4563 402 +4564 403 +4565 403 +4566 402 +4567 403 +4568 403 +4569 402 +4570 403 +4571 403 +4572 402 +4573 403 +4574 403 +4575 402 +4576 403 +4577 403 +4578 402 +4579 403 +4580 403 +4581 402 +4582 403 +4583 403 +4584 402 +4585 403 +4586 403 +4587 402 +4588 403 +4589 403 +4590 402 +4591 403 +4592 403 +4593 402 +4594 403 +4595 403 +4596 402 +4597 403 +4598 403 +4599 402 +4600 403 +4601 403 +4602 402 +4603 403 +4604 403 +4605 402 +4606 403 +4607 403 +4608 402 +4609 403 +4610 403 +4611 402 +4612 403 +4613 403 +4614 402 +4615 403 +4616 403 +4617 402 +4618 403 +4619 403 +4620 402 +4621 403 +4622 403 +4623 402 +4624 403 +4625 403 +4626 402 +4627 403 +4628 403 +4629 402 +4630 403 +4631 403 +4632 402 +4633 403 +4634 403 +4635 402 +4636 403 +4637 403 +4638 402 +4639 403 +4640 403 +4641 402 +4642 403 +4643 403 +4644 402 +4645 403 +4646 403 +4647 402 +4648 403 +4649 403 +4650 402 +4651 403 +4652 403 +4653 402 +4654 403 +4655 403 +4656 402 +4657 403 +4658 403 +4659 402 +4660 403 +4661 403 +4662 402 +4663 403 +4664 403 +4665 402 +4666 403 +4667 403 +4668 402 +4669 403 +4670 403 +4671 402 +4672 403 +4673 403 +4674 402 +4675 403 +4676 403 +4677 402 +4678 403 +4679 403 +4680 402 +4681 403 +4682 403 +4683 402 +4684 403 +4685 403 +4686 402 +4687 403 +4688 403 +4689 402 +4690 403 +4691 403 +4692 402 +4693 403 +4694 403 +4695 402 +4696 403 +4697 403 +4698 402 +4699 403 +4700 403 +4701 402 +4702 403 +4703 403 +4704 402 +4705 403 +4706 403 +4707 402 +4708 403 +4709 403 +4710 402 +4711 403 +4712 403 +4713 402 +4714 403 +4715 403 +4716 402 +4717 403 +4718 403 +4719 402 +4720 403 +4721 403 +4722 402 +4723 403 +4724 403 +4725 402 +4726 403 +4727 403 +4728 402 +4729 403 +4730 403 +4731 402 +4732 403 +4733 403 +4734 402 +4735 403 +4736 403 +4737 402 +4738 403 +4739 403 +4740 402 +4741 403 +4742 403 +4743 402 +4744 403 +4745 403 +4746 402 +4747 403 +4748 403 +4749 402 +4750 403 +4751 403 +4752 402 +4753 403 +4754 403 +4755 402 +4756 403 +4757 403 +4758 402 +4759 403 +4760 403 +4761 402 +4762 403 +4763 403 +4764 402 +4765 403 +4766 403 +4767 402 +4768 403 +4769 403 +4770 402 +4771 403 +4772 403 +4773 402 +4774 403 +4775 403 +4776 402 +4777 403 +4778 403 +4779 402 +4780 403 +4781 403 +4782 402 +4783 403 +4784 403 +4785 402 +4786 403 +4787 403 +4788 402 +4789 403 +4790 403 +4791 402 +4792 403 +4793 403 +4794 402 +4795 403 +4796 403 +4797 402 +4798 403 +4799 403 +4800 402 +4801 403 +4802 403 +4803 402 +4804 403 +4805 403 +4806 402 +4807 403 +4808 403 +4809 402 +4810 403 +4811 403 +4812 402 +4813 403 +4814 403 +4815 402 +4816 403 +4817 403 +4818 402 +4819 403 +4820 403 +4821 402 +4822 403 +4823 403 +4824 402 +4825 403 +4826 403 +4827 402 +4828 403 +4829 403 +4830 402 +4831 403 +4832 403 +4833 402 +4834 403 +4835 403 +4836 402 +4837 403 +4838 403 +4839 402 +4840 403 +4841 403 +4842 402 +4843 403 +4844 403 +4845 402 +4846 403 +4847 403 +4848 402 +4849 403 +4850 403 +4851 402 +4852 403 +4853 403 +4854 402 +4855 403 +4856 403 +4857 402 +4858 403 +4859 403 +4860 402 +4861 403 +4862 403 +4863 402 +4864 403 +4865 403 +4866 402 +4867 403 +4868 403 +4869 402 +4870 403 +4871 403 +4872 402 +4873 403 +4874 403 +4875 402 +4876 403 +4877 403 +4878 402 +4879 403 +4880 403 +4881 402 +4882 403 +4883 403 +4884 402 +4885 403 +4886 403 +4887 402 +4888 403 +4889 403 +4890 402 +4891 403 +4892 403 +4893 402 +4894 403 +4895 403 +4896 402 +4897 403 +4898 403 +4899 402 +4900 403 +4901 403 +4902 402 +4903 403 +4904 403 +4905 402 +4906 403 +4907 403 +4908 402 +4909 403 +4910 403 +4911 402 +4912 403 +4913 403 +4914 402 +4915 403 +4916 403 +4917 402 +4918 403 +4919 403 +4920 402 +4921 403 +4922 403 +4923 402 +4924 403 +4925 403 +4926 402 +4927 403 +4928 403 +4929 402 +4930 403 +4931 403 +4932 402 +4933 403 +4934 403 +4935 402 +4936 403 +4937 403 +4938 402 +4939 403 +4940 403 +4941 402 +4942 403 +4943 403 +4944 402 +4945 403 +4946 403 +4947 402 +4948 403 +4949 403 +4950 402 +4951 403 +4952 403 +4953 402 +4954 403 +4955 403 +4956 402 +4957 403 +4958 403 +4959 402 +4960 403 +4961 403 +4962 402 +4963 403 +4964 403 +4965 402 +4966 403 +4967 403 +4968 402 +4969 403 +4970 403 +4971 402 +4972 403 +4973 403 +4974 402 +4975 403 +4976 403 +4977 402 +4978 403 +4979 403 +4980 402 +4981 403 +4982 403 +4983 402 +4984 403 +4985 403 +4986 402 +4987 403 +4988 403 +4989 402 +4990 403 +4991 403 +4992 402 +4993 403 +4994 403 +4995 402 +4996 403 +4997 403 +4998 402 +4999 403 +5000 403 +5001 402 +5002 403 +5003 403 +5004 402 +5005 403 +5006 403 +5007 402 +5008 403 +5009 403 +5010 402 +5011 403 +5012 403 +5013 402 +5014 403 +5015 403 +5016 402 +5017 403 +5018 403 +5019 402 +5020 403 +5021 403 +5022 402 +5023 403 +5024 403 +5025 402 +5026 403 +5027 403 +5028 402 +5029 403 +5030 403 +5031 402 +5032 403 +5033 403 +5034 402 +5035 403 +5036 403 +5037 402 +5038 403 +5039 403 +5040 402 +5041 403 +5042 403 +5043 402 +5044 403 +5045 403 +5046 402 +5047 403 +5048 403 +5049 402 +5050 403 +5051 403 +5052 402 +5053 403 +5054 403 +5055 402 +5056 403 +5057 403 +5058 402 +5059 403 +5060 403 +5061 402 +5062 403 +5063 403 +5064 402 +5065 403 +5066 403 +5067 402 +5068 403 +5069 403 +5070 402 +5071 403 +5072 403 +5073 402 +5074 403 +5075 403 +5076 402 +5077 403 +5078 403 +5079 402 +5080 403 +5081 403 +5082 402 +5083 403 +5084 403 +5085 402 +5086 403 +5087 403 +5088 402 +5089 403 +5090 403 +5091 402 +5092 403 +5093 403 +5094 402 +5095 403 +5096 403 +5097 402 +5098 403 +5099 403 +5100 402 +5101 403 +5102 403 +5103 402 +5104 403 +5105 403 +5106 402 +5107 403 +5108 403 +5109 402 +5110 403 +5111 403 +5112 402 +5113 403 +5114 403 +5115 402 +5116 403 +5117 403 +5118 402 +5119 403 +5120 403 +5121 402 +5122 403 +5123 403 +5124 402 +5125 403 +5126 403 +5127 402 +5128 403 +5129 403 +5130 402 +5131 403 +5132 403 +5133 402 +5134 403 +5135 403 +5136 402 +5137 403 +5138 403 +5139 402 +5140 403 +5141 403 +5142 402 +5143 403 +5144 403 +5145 402 +5146 403 +5147 403 +5148 402 +5149 403 +5150 403 +5151 402 +5152 403 +5153 403 +5154 402 +5155 403 +5156 403 +5157 402 +5158 403 +5159 403 +5160 402 +5161 403 +5162 403 +5163 402 +5164 403 +5165 403 +5166 402 +5167 403 +5168 403 +5169 402 +5170 403 +5171 403 +5172 402 +5173 403 +5174 403 +5175 402 +5176 403 +5177 403 +5178 402 +5179 403 +5180 403 +5181 402 +5182 403 +5183 403 +5184 402 +5185 403 +5186 403 +5187 402 +5188 403 +5189 403 +5190 402 +5191 403 +5192 403 +5193 402 +5194 403 +5195 403 +5196 402 +5197 403 +5198 403 +5199 402 +5200 403 +5201 403 +5202 402 +5203 403 +5204 403 +5205 402 +5206 403 +5207 403 +5208 402 +5209 403 +5210 403 +5211 402 +5212 403 +5213 403 +5214 402 +5215 403 +5216 403 +5217 402 +5218 403 +5219 403 +5220 402 +5221 403 +5222 403 +5223 402 +5224 403 +5225 403 +5226 402 +5227 403 +5228 403 +5229 402 +5230 403 +5231 403 +5232 402 +5233 403 +5234 403 +5235 402 +5236 403 +5237 403 +5238 402 +5239 403 +5240 403 +5241 402 +5242 403 +5243 403 +5244 402 +5245 403 +5246 403 +5247 402 +5248 403 +5249 403 +5250 402 +5251 403 +5252 403 +5253 402 +5254 403 +5255 403 +5256 402 +5257 403 +5258 403 +5259 402 +5260 403 +5261 403 +5262 402 +5263 403 +5264 403 +5265 402 +5266 403 +5267 403 +5268 402 +5269 403 +5270 403 +5271 402 +5272 403 +5273 403 +5274 402 +5275 403 +5276 403 +5277 402 +5278 403 +5279 403 +5280 402 +5281 403 +5282 403 +5283 402 +5284 403 +5285 403 +5286 402 +5287 403 +5288 403 +5289 402 +5290 403 +5291 403 +5292 402 +5293 403 +5294 403 +5295 402 +5296 403 +5297 403 +5298 402 +5299 403 +5300 403 +5301 402 +5302 403 +5303 403 +5304 402 +5305 403 +5306 403 +5307 402 +5308 403 +5309 403 +5310 402 +5311 403 +5312 403 +5313 402 +5314 403 +5315 403 +5316 402 +5317 403 +5318 403 +5319 402 +5320 403 +5321 403 +5322 402 +5323 403 +5324 403 +5325 402 +5326 403 +5327 403 +5328 402 +5329 403 +5330 403 +5331 402 +5332 403 +5333 403 +5334 402 +5335 403 +5336 403 +5337 402 +5338 403 +5339 403 +5340 402 +5341 403 +5342 403 +5343 402 +5344 403 +5345 403 +5346 402 +5347 403 +5348 403 +5349 402 +5350 403 +5351 403 +5352 402 +5353 403 +5354 403 +5355 402 +5356 403 +5357 403 +5358 402 +5359 403 +5360 403 +5361 402 +5362 403 +5363 403 +5364 402 +5365 403 +5366 403 +5367 402 +5368 403 +5369 403 +5370 402 +5371 403 +5372 403 +5373 402 +5374 403 +5375 403 +5376 402 +5377 403 +5378 403 +5379 402 +5380 403 +5381 403 +5382 402 +5383 403 +5384 403 +5385 402 +5386 403 +5387 403 +5388 402 +5389 403 +5390 403 +5391 402 +5392 403 +5393 403 +5394 402 +5395 403 +5396 403 +5397 402 +5398 403 +5399 403 +5400 402 +5401 403 +5402 403 +5403 402 +5404 403 +5405 403 +5406 402 +5407 403 +5408 403 +5409 402 +5410 403 +5411 403 +5412 402 +5413 403 +5414 403 +5415 402 +5416 403 +5417 403 +5418 402 +5419 403 +5420 403 +5421 402 +5422 403 +5423 403 +5424 402 +5425 403 +5426 403 +5427 402 +5428 403 +5429 403 +5430 402 +5431 403 +5432 403 +5433 402 +5434 403 +5435 403 +5436 402 +5437 403 +5438 403 +5439 402 +5440 403 +5441 403 +5442 402 +5443 403 +5444 403 +5445 402 +5446 403 +5447 403 +5448 402 +5449 403 +5450 403 +5451 402 +5452 403 +5453 403 +5454 402 +5455 403 +5456 403 +5457 402 +5458 403 +5459 403 +5460 402 +5461 403 +5462 403 +5463 402 +5464 403 +5465 403 +5466 402 +5467 403 +5468 403 +5469 402 +5470 403 +5471 403 +5472 402 +5473 403 +5474 403 +5475 402 +5476 403 +5477 403 +5478 402 +5479 403 +5480 403 +5481 402 +5482 403 +5483 403 +5484 402 +5485 403 +5486 403 +5487 402 +5488 403 +5489 403 +5490 402 +5491 403 +5492 403 +5493 402 +5494 403 +5495 403 +5496 402 +5497 403 +5498 403 +5499 402 +5500 403 +5501 403 +5502 402 +5503 403 +5504 403 +5505 402 +5506 403 +5507 403 +5508 402 +5509 403 +5510 403 +5511 402 +5512 403 +5513 403 +5514 402 +5515 403 +5516 403 +5517 402 +5518 403 +5519 403 +5520 402 +5521 403 +5522 403 +5523 402 +5524 403 +5525 403 +5526 402 +5527 403 +5528 403 +5529 402 +5530 403 +5531 403 +5532 402 +5533 403 +5534 403 +5535 402 +5536 403 +5537 403 +5538 402 +5539 403 +5540 403 +5541 402 +5542 403 +5543 403 +5544 402 +5545 403 +5546 403 +5547 402 +5548 403 +5549 403 +5550 402 +5551 403 +5552 403 +5553 402 +5554 403 +5555 403 +5556 402 +5557 403 +5558 403 +5559 402 +5560 403 +5561 403 +5562 402 +5563 403 +5564 403 +5565 402 +5566 403 +5567 403 +5568 402 +5569 403 +5570 403 +5571 402 +5572 403 +5573 403 +5574 402 +5575 403 +5576 403 +5577 402 +5578 403 +5579 403 +5580 402 +5581 403 +5582 403 +5583 402 +5584 403 +5585 403 +5586 402 +5587 403 +5588 403 +5589 402 +5590 403 +5591 403 +5592 402 +5593 403 +5594 403 +5595 402 +5596 403 +5597 403 +5598 402 +5599 403 +5600 403 +5601 402 +5602 403 +5603 403 +5604 402 +5605 403 +5606 403 +5607 402 +5608 403 +5609 403 +5610 402 +5611 403 +5612 403 +5613 402 +5614 403 +5615 403 +5616 402 +5617 403 +5618 403 +5619 402 +5620 403 +5621 403 +5622 402 +5623 403 +5624 403 +5625 402 +5626 403 +5627 403 +5628 402 +5629 403 +5630 403 +5631 402 +5632 403 +5633 403 +5634 402 +5635 403 +5636 403 +5637 402 +5638 403 +5639 403 +5640 402 +5641 403 +5642 403 +5643 402 +5644 403 +5645 403 +5646 402 +5647 403 +5648 403 +5649 402 +5650 403 +5651 403 +5652 402 +5653 403 +5654 403 +5655 402 +5656 403 +5657 403 +5658 402 +5659 403 +5660 403 +5661 402 +5662 403 +5663 403 +5664 402 +5665 403 +5666 403 +5667 402 +5668 403 +5669 403 +5670 402 +5671 403 +5672 403 +5673 402 +5674 403 +5675 403 +5676 402 +5677 403 +5678 403 +5679 402 +5680 403 +5681 403 +5682 402 +5683 403 +5684 403 +5685 402 +5686 403 +5687 403 +5688 402 +5689 403 +5690 403 +5691 402 +5692 403 +5693 403 +5694 402 +5695 403 +5696 403 +5697 402 +5698 403 +5699 403 +5700 402 +5701 403 +5702 403 +5703 402 +5704 403 +5705 403 +5706 402 +5707 403 +5708 403 +5709 402 +5710 403 +5711 403 +5712 402 +5713 403 +5714 403 +5715 402 +5716 403 +5717 403 +5718 402 +5719 403 +5720 403 +5721 402 +5722 403 +5723 403 +5724 402 +5725 403 +5726 403 +5727 402 +5728 403 +5729 403 +5730 402 +5731 403 +5732 403 +5733 402 +5734 403 +5735 403 +5736 402 +5737 403 +5738 403 +5739 402 +5740 403 +5741 403 +5742 402 +5743 403 +5744 403 +5745 402 +5746 403 +5747 403 +5748 402 +5749 403 +5750 403 +5751 402 +5752 403 +5753 403 +5754 402 +5755 403 +5756 403 +5757 402 +5758 403 +5759 403 +5760 402 +5761 403 +5762 403 +5763 402 +5764 403 +5765 403 +5766 402 +5767 403 +5768 403 +5769 402 +5770 403 +5771 403 +5772 402 +5773 403 +5774 403 +5775 402 +5776 403 +5777 403 +5778 402 +5779 403 +5780 403 +5781 402 +5782 403 +5783 403 +5784 402 +5785 403 +5786 403 +5787 402 +5788 403 +5789 403 +5790 402 +5791 403 +5792 403 +5793 402 +5794 403 +5795 403 +5796 402 +5797 403 +5798 403 +5799 402 +5800 403 +5801 403 +5802 402 +5803 403 +5804 403 +5805 402 +5806 403 +5807 403 +5808 402 +5809 403 +5810 403 +5811 402 +5812 403 +5813 403 +5814 402 +5815 403 +5816 403 +5817 402 +5818 403 +5819 403 +5820 402 +5821 403 +5822 403 +5823 402 +5824 403 +5825 403 +5826 402 +5827 403 +5828 403 +5829 402 +5830 403 +5831 403 +5832 402 +5833 403 +5834 403 +5835 402 +5836 403 +5837 403 +5838 402 +5839 403 +5840 403 +5841 402 +5842 403 +5843 403 +5844 402 +5845 403 +5846 403 +5847 402 +5848 403 +5849 403 +5850 402 +5851 403 +5852 403 +5853 402 +5854 403 +5855 403 +5856 402 +5857 403 +5858 403 +5859 402 +5860 403 +5861 403 +5862 402 +5863 403 +5864 403 +5865 402 +5866 403 +5867 403 +5868 402 +5869 403 +5870 403 +5871 402 +5872 403 +5873 403 +5874 402 +5875 403 +5876 403 +5877 402 +5878 403 +5879 403 +5880 402 +5881 403 +5882 403 +5883 402 +5884 403 +5885 403 +5886 402 +5887 403 +5888 403 +5889 402 +5890 403 +5891 403 +5892 402 +5893 403 +5894 403 +5895 402 +5896 403 +5897 403 +5898 402 +5899 403 +5900 403 +5901 402 +5902 403 +5903 403 +5904 402 +5905 403 +5906 403 +5907 402 +5908 403 +5909 403 +5910 402 +5911 403 +5912 403 +5913 402 +5914 403 +5915 403 +5916 402 +5917 403 +5918 403 +5919 402 +5920 403 +5921 403 +5922 402 +5923 403 +5924 403 +5925 402 +5926 403 +5927 403 +5928 402 +5929 403 +5930 403 +5931 402 +5932 403 +5933 403 +5934 402 +5935 403 +5936 403 +5937 402 +5938 403 +5939 403 +5940 402 +5941 403 +5942 403 +5943 402 +5944 403 +5945 403 +5946 402 +5947 403 +5948 403 +5949 402 +5950 403 +5951 403 +5952 402 +5953 403 +5954 403 +5955 402 +5956 403 +5957 403 +5958 402 +5959 403 +5960 403 +5961 402 +5962 403 +5963 403 +5964 402 +5965 403 +5966 403 +5967 402 +5968 403 +5969 403 +5970 402 +5971 403 +5972 403 +5973 402 +5974 403 +5975 403 +5976 402 +5977 403 +5978 403 +5979 402 +5980 403 +5981 403 +5982 402 +5983 403 +5984 403 +5985 402 +5986 403 +5987 403 +5988 402 +5989 403 +5990 403 +5991 402 +5992 403 +5993 403 +5994 402 +5995 403 +5996 403 +5997 402 +5998 403 +5999 403 +6000 402 +6001 403 +6002 403 +6003 402 +6004 403 +6005 403 +6006 402 +6007 403 +6008 403 +6009 402 +6010 403 +6011 403 +6012 402 +6013 403 +6014 403 +6015 402 +6016 403 +6017 403 +6018 402 +6019 403 +6020 403 +6021 402 +6022 403 +6023 403 +6024 402 +6025 403 +6026 403 +6027 402 +6028 403 +6029 403 +6030 402 +6031 403 +6032 403 +6033 402 +6034 403 +6035 403 +6036 402 +6037 403 +6038 403 +6039 402 +6040 403 +6041 403 +6042 402 +6043 403 +6044 403 +6045 402 +6046 403 +6047 403 +6048 402 +6049 403 +6050 403 +6051 402 +6052 403 +6053 403 +6054 402 +6055 403 +6056 403 +6057 402 +6058 403 +6059 403 +6060 402 +6061 403 +6062 403 +6063 402 +6064 403 +6065 403 +6066 402 +6067 403 +6068 403 +6069 402 +6070 403 +6071 403 +6072 402 +6073 403 +6074 403 +6075 402 +6076 403 +6077 403 +6078 402 +6079 403 +6080 403 +6081 402 +6082 403 +6083 403 +6084 402 +6085 403 +6086 403 +6087 402 +6088 403 +6089 403 +6090 402 +6091 403 +6092 403 +6093 402 +6094 403 +6095 403 +6096 402 +6097 403 +6098 403 +6099 402 +6100 403 +6101 403 +6102 402 +6103 403 +6104 403 +6105 402 +6106 403 +6107 403 +6108 402 +6109 403 +6110 403 +6111 402 +6112 403 +6113 403 +6114 402 +6115 403 +6116 403 +6117 402 +6118 403 +6119 403 +6120 402 +6121 403 +6122 403 +6123 402 +6124 403 +6125 403 +6126 402 +6127 403 +6128 403 +6129 402 +6130 403 +6131 403 +6132 402 +6133 403 +6134 403 +6135 402 +6136 403 +6137 403 +6138 402 +6139 403 +6140 403 +6141 402 +6142 403 +6143 403 +6144 402 +6145 403 +6146 403 +6147 402 +6148 403 +6149 403 +6150 402 +6151 403 +6152 403 +6153 402 +6154 403 +6155 403 +6156 402 +6157 403 +6158 403 +6159 402 +6160 403 +6161 403 +6162 402 +6163 403 +6164 403 +6165 402 +6166 403 +6167 403 +6168 402 +6169 403 +6170 403 +6171 402 +6172 403 +6173 403 +6174 402 +6175 403 +6176 403 +6177 402 +6178 403 +6179 403 +6180 402 +6181 403 +6182 403 +6183 402 +6184 403 +6185 403 +6186 402 +6187 403 +6188 403 +6189 402 +6190 403 +6191 403 +6192 402 +6193 403 +6194 403 +6195 402 +6196 403 +6197 403 +6198 402 +6199 403 +6200 403 +6201 402 +6202 403 +6203 403 +6204 402 +6205 403 +6206 403 +6207 402 +6208 403 +6209 403 +6210 402 +6211 403 +6212 403 +6213 402 +6214 403 +6215 403 +6216 402 +6217 403 +6218 403 +6219 402 +6220 403 +6221 403 +6222 402 +6223 403 +6224 403 +6225 402 +6226 403 +6227 403 +6228 402 +6229 403 +6230 403 +6231 402 +6232 403 +6233 403 +6234 402 +6235 403 +6236 403 +6237 402 +6238 403 +6239 403 +6240 402 +6241 403 +6242 403 +6243 402 +6244 403 +6245 403 +6246 402 +6247 403 +6248 403 +6249 402 +6250 403 +6251 403 +6252 402 +6253 403 +6254 403 +6255 402 +6256 403 +6257 403 +6258 402 +6259 403 +6260 403 +6261 402 +6262 403 +6263 403 +6264 402 +6265 403 +6266 403 +6267 402 +6268 403 +6269 403 +6270 402 +6271 403 +6272 403 +6273 402 +6274 403 +6275 403 +6276 402 +6277 403 +6278 403 +6279 402 +6280 403 +6281 403 +6282 402 +6283 403 +6284 403 +6285 402 +6286 403 +6287 403 +6288 402 +6289 403 +6290 403 +6291 402 +6292 403 +6293 403 +6294 402 +6295 403 +6296 403 +6297 402 +6298 403 +6299 403 +6300 402 +6301 403 +6302 403 +6303 402 +6304 403 +6305 403 +6306 402 +6307 403 +6308 403 +6309 402 +6310 403 +6311 403 +6312 402 +6313 403 +6314 403 +6315 402 +6316 403 +6317 403 +6318 402 +6319 403 +6320 403 +6321 402 +6322 403 +6323 403 +6324 402 +6325 403 +6326 403 +6327 402 +6328 403 +6329 403 +6330 402 +6331 403 +6332 403 +6333 402 +6334 403 +6335 403 +6336 402 +6337 403 +6338 403 +6339 402 +6340 403 +6341 403 +6342 402 +6343 403 +6344 403 +6345 402 +6346 403 +6347 403 +6348 402 +6349 403 +6350 403 +6351 402 +6352 403 +6353 403 +6354 402 +6355 403 +6356 403 +6357 402 +6358 403 +6359 403 +6360 402 +6361 403 +6362 403 +6363 402 +6364 403 +6365 403 +6366 402 +6367 403 +6368 403 +6369 402 +6370 403 +6371 403 +6372 402 +6373 403 +6374 403 +6375 402 +6376 403 +6377 403 +6378 402 +6379 403 +6380 403 +6381 402 +6382 403 +6383 403 +6384 402 +6385 403 +6386 403 +6387 402 +6388 403 +6389 403 +6390 402 +6391 403 +6392 403 +6393 402 +6394 403 +6395 403 +6396 402 +6397 403 +6398 403 +6399 402 +6400 403 +6401 403 +6402 402 +6403 403 +6404 403 +6405 402 +6406 403 +6407 403 +6408 402 +6409 403 +6410 403 +6411 402 +6412 403 +6413 403 +6414 402 +6415 403 +6416 403 +6417 402 +6418 403 +6419 403 +6420 402 +6421 403 +6422 403 +6423 402 +6424 403 +6425 403 +6426 402 +6427 403 +6428 403 +6429 402 +6430 403 +6431 403 +6432 402 +6433 403 +6434 403 +6435 402 +6436 403 +6437 403 +6438 402 +6439 403 +6440 403 +6441 402 +6442 403 +6443 403 +6444 402 +6445 403 +6446 403 +6447 402 +6448 403 +6449 403 +6450 402 +6451 403 +6452 403 +6453 402 +6454 403 +6455 403 +6456 402 +6457 403 +6458 403 +6459 402 +6460 403 +6461 403 +6462 402 +6463 403 +6464 403 +6465 402 +6466 403 +6467 403 +6468 402 +6469 403 +6470 403 +6471 402 +6472 403 +6473 403 +6474 402 +6475 403 +6476 403 +6477 402 +6478 403 +6479 403 +6480 402 +6481 403 +6482 403 +6483 402 +6484 403 +6485 403 +6486 402 +6487 403 +6488 403 +6489 402 +6490 403 +6491 403 +6492 402 +6493 403 +6494 403 +6495 402 +6496 403 +6497 403 +6498 402 +6499 403 +6500 403 +6501 402 +6502 403 +6503 403 +6504 402 +6505 403 +6506 403 +6507 402 +6508 403 +6509 403 +6510 402 +6511 403 +6512 403 +6513 402 +6514 403 +6515 403 +6516 402 +6517 403 +6518 403 +6519 402 +6520 403 +6521 403 +6522 402 +6523 403 +6524 403 +6525 402 +6526 403 +6527 403 +6528 402 +6529 403 +6530 403 +6531 402 +6532 403 +6533 403 +6534 402 +6535 403 +6536 403 +6537 402 +6538 403 +6539 403 +6540 402 +6541 403 +6542 403 +6543 402 +6544 403 +6545 403 +6546 402 +6547 403 +6548 403 +6549 402 +6550 403 +6551 403 +6552 402 +6553 403 +6554 403 +6555 402 +6556 403 +6557 403 +6558 402 +6559 403 +6560 403 +6561 402 +6562 403 +6563 403 +6564 402 +6565 403 +6566 403 +6567 402 +6568 403 +6569 403 +6570 402 +6571 403 +6572 403 +6573 402 +6574 403 +6575 403 +6576 402 +6577 403 +6578 403 +6579 402 +6580 403 +6581 403 +6582 402 +6583 403 +6584 403 +6585 402 +6586 403 +6587 403 +6588 402 +6589 403 +6590 403 +6591 402 +6592 403 +6593 403 +6594 402 +6595 403 +6596 403 +6597 402 +6598 403 +6599 403 +6600 402 +6601 403 +6602 403 +6603 402 +6604 403 +6605 403 +6606 402 +6607 403 +6608 403 +6609 402 +6610 403 +6611 403 +6612 402 +6613 403 +6614 403 +6615 402 +6616 403 +6617 403 +6618 402 +6619 403 +6620 403 +6621 402 +6622 403 +6623 403 +6624 402 +6625 403 +6626 403 +6627 402 +6628 403 +6629 403 +6630 402 +6631 403 +6632 403 +6633 402 +6634 403 +6635 403 +6636 402 +6637 403 +6638 403 +6639 402 +6640 403 +6641 403 +6642 402 +6643 403 +6644 403 +6645 402 +6646 403 +6647 403 +6648 402 +6649 403 +6650 403 +6651 402 +6652 403 +6653 403 +6654 402 +6655 403 +6656 403 +6657 402 +6658 403 +6659 403 +6660 402 +6661 403 +6662 403 +6663 402 +6664 403 +6665 403 +6666 402 +6667 403 +6668 403 +6669 402 +6670 403 +6671 403 +6672 402 +6673 403 +6674 403 +6675 402 +6676 403 +6677 403 +6678 402 +6679 403 +6680 403 +6681 402 +6682 403 +6683 403 +6684 402 +6685 403 +6686 403 +6687 402 +6688 403 +6689 403 +6690 402 +6691 403 +6692 403 +6693 402 +6694 403 +6695 403 +6696 402 +6697 403 +6698 403 +6699 402 +6700 403 +6701 403 +6702 402 +6703 403 +6704 403 +6705 402 +6706 403 +6707 403 +6708 402 +6709 403 +6710 403 +6711 402 +6712 403 +6713 403 +6714 402 +6715 403 +6716 403 +6717 402 +6718 403 +6719 403 +6720 402 +6721 403 +6722 403 +6723 402 +6724 403 +6725 403 +6726 402 +6727 403 +6728 403 +6729 402 +6730 403 +6731 403 +6732 402 +6733 403 +6734 403 +6735 402 +6736 403 +6737 403 +6738 402 +6739 403 +6740 403 +6741 402 +6742 403 +6743 403 +6744 402 +6745 403 +6746 403 +6747 402 +6748 403 +6749 403 +6750 402 +6751 403 +6752 403 +6753 402 +6754 403 +6755 403 +6756 402 +6757 403 +6758 403 +6759 402 +6760 403 +6761 403 +6762 402 +6763 403 +6764 403 +6765 402 +6766 403 +6767 403 +6768 402 +6769 403 +6770 403 +6771 402 +6772 403 +6773 403 +6774 402 +6775 403 +6776 403 +6777 402 +6778 403 +6779 403 +6780 402 +6781 403 +6782 403 +6783 402 +6784 403 +6785 403 +6786 402 +6787 403 +6788 403 +6789 402 +6790 403 +6791 403 +6792 402 +6793 403 +6794 403 +6795 402 +6796 403 +6797 403 +6798 402 +6799 403 +6800 403 +6801 402 +6802 403 +6803 403 +6804 402 +6805 403 +6806 403 +6807 402 +6808 403 +6809 403 +6810 402 +6811 403 +6812 403 +6813 402 +6814 403 +6815 403 +6816 402 +6817 403 +6818 403 +6819 402 +6820 403 +6821 403 +6822 402 +6823 403 +6824 403 +6825 402 +6826 403 +6827 403 +6828 402 +6829 403 +6830 403 +6831 402 +6832 403 +6833 403 +6834 402 +6835 403 +6836 403 +6837 402 +6838 403 +6839 403 +6840 402 +6841 403 +6842 403 +6843 402 +6844 403 +6845 403 +6846 402 +6847 403 +6848 403 +6849 402 +6850 403 +6851 403 +6852 402 +6853 403 +6854 403 +6855 402 +6856 403 +6857 403 +6858 402 +6859 403 +6860 403 +6861 402 +6862 403 +6863 403 +6864 402 +6865 403 +6866 403 +6867 402 +6868 403 +6869 403 +6870 402 +6871 403 +6872 403 +6873 402 +6874 403 +6875 403 +6876 402 +6877 403 +6878 403 +6879 402 +6880 403 +6881 403 +6882 402 +6883 403 +6884 403 +6885 402 +6886 403 +6887 403 +6888 402 +6889 403 +6890 403 +6891 402 +6892 403 +6893 403 +6894 402 +6895 403 +6896 403 +6897 402 +6898 403 +6899 403 +6900 402 +6901 403 +6902 403 +6903 402 +6904 403 +6905 403 +6906 402 +6907 403 +6908 403 +6909 402 +6910 403 +6911 403 +6912 402 +6913 403 +6914 403 +6915 402 +6916 403 +6917 403 +6918 402 +6919 403 +6920 403 +6921 402 +6922 403 +6923 403 +6924 402 +6925 403 +6926 403 +6927 402 +6928 403 +6929 403 +6930 402 +6931 403 +6932 403 +6933 402 +6934 403 +6935 403 +6936 402 +6937 403 +6938 403 +6939 402 +6940 403 +6941 403 +6942 402 +6943 403 +6944 403 +6945 402 +6946 403 +6947 403 +6948 402 +6949 403 +6950 403 +6951 402 +6952 403 +6953 403 +6954 402 +6955 403 +6956 403 +6957 402 +6958 403 +6959 403 +6960 402 +6961 403 +6962 403 +6963 402 +6964 403 +6965 403 +6966 402 +6967 403 +6968 403 +6969 402 +6970 403 +6971 403 +6972 402 +6973 403 +6974 403 +6975 402 +6976 403 +6977 403 +6978 402 +6979 403 +6980 403 +6981 402 +6982 403 +6983 403 +6984 402 +6985 403 +6986 403 +6987 402 +6988 403 +6989 403 +6990 402 +6991 403 +6992 403 +6993 402 +6994 403 +6995 403 +6996 402 +6997 403 +6998 403 +6999 402 +7000 403 +7001 403 +7002 402 +7003 403 +7004 403 +7005 402 +7006 403 +7007 403 +7008 402 +7009 403 +7010 403 +7011 402 +7012 403 +7013 403 +7014 402 +7015 403 +7016 403 +7017 402 +7018 403 +7019 403 +7020 402 +7021 403 +7022 403 +7023 402 +7024 403 +7025 403 +7026 402 +7027 403 +7028 403 +7029 402 +7030 403 +7031 403 +7032 402 +7033 403 +7034 403 +7035 402 +7036 403 +7037 403 +7038 402 +7039 403 +7040 403 +7041 402 +7042 403 +7043 403 +7044 402 +7045 403 +7046 403 +7047 402 +7048 403 +7049 403 +7050 402 +7051 403 +7052 403 +7053 402 +7054 403 +7055 403 +7056 402 +7057 403 +7058 403 +7059 402 +7060 403 +7061 403 +7062 402 +7063 403 +7064 403 +7065 402 +7066 403 +7067 403 +7068 402 +7069 403 +7070 403 +7071 402 +7072 403 +7073 403 +7074 402 +7075 403 +7076 403 +7077 402 +7078 403 +7079 403 +7080 402 +7081 403 +7082 403 +7083 402 +7084 403 +7085 403 +7086 402 +7087 403 +7088 403 +7089 402 +7090 403 +7091 403 +7092 402 +7093 403 +7094 403 +7095 402 +7096 403 +7097 403 +7098 402 +7099 403 +7100 403 +7101 402 +7102 403 +7103 403 +7104 402 +7105 403 +7106 403 +7107 402 +7108 403 +7109 403 +7110 402 +7111 403 +7112 403 +7113 402 +7114 403 +7115 403 +7116 402 +7117 403 +7118 403 +7119 402 +7120 403 +7121 403 +7122 402 +7123 403 +7124 403 +7125 402 +7126 403 +7127 403 +7128 402 +7129 403 +7130 403 +7131 402 +7132 403 +7133 403 +7134 402 +7135 403 +7136 403 +7137 402 +7138 403 +7139 403 +7140 402 +7141 403 +7142 403 +7143 402 +7144 403 +7145 403 +7146 402 +7147 403 +7148 403 +7149 402 +7150 403 +7151 403 +7152 402 +7153 403 +7154 403 +7155 402 +7156 403 +7157 403 +7158 402 +7159 403 +7160 403 +7161 402 +7162 403 +7163 403 +7164 402 +7165 403 +7166 403 +7167 402 +7168 403 +7169 403 +7170 402 +7171 403 +7172 403 +7173 402 +7174 403 +7175 403 +7176 402 +7177 403 +7178 403 +7179 402 +7180 403 +7181 403 +7182 402 +7183 403 +7184 403 +7185 402 +7186 403 +7187 403 +7188 402 +7189 403 +7190 403 +7191 402 +7192 403 +7193 403 +7194 402 +7195 403 +7196 403 +7197 402 +7198 403 +7199 403 +7200 402 +7201 403 +7202 403 +7203 402 +7204 403 +7205 403 +7206 402 +7207 403 +7208 403 +7209 402 +7210 403 +7211 403 +7212 402 +7213 403 +7214 403 +7215 402 +7216 403 +7217 403 +7218 402 +7219 403 +7220 403 +7221 402 +7222 403 +7223 403 +7224 402 +7225 403 +7226 403 +7227 402 +7228 403 +7229 403 +7230 402 +7231 403 +7232 403 +7233 402 +7234 403 +7235 403 +7236 402 +7237 403 +7238 403 +7239 402 +7240 403 +7241 403 +7242 402 +7243 403 +7244 403 +7245 402 +7246 403 +7247 403 +7248 402 +7249 403 +7250 403 +7251 402 +7252 403 +7253 403 +7254 402 +7255 403 +7256 403 +7257 402 +7258 403 +7259 403 +7260 402 +7261 403 +7262 403 +7263 402 +7264 403 +7265 403 +7266 402 +7267 403 +7268 403 +7269 402 +7270 403 +7271 403 +7272 402 +7273 403 +7274 403 +7275 402 +7276 403 +7277 403 +7278 402 +7279 403 +7280 403 +7281 402 +7282 403 +7283 403 +7284 402 +7285 403 +7286 403 +7287 402 +7288 403 +7289 403 +7290 402 +7291 403 +7292 403 +7293 402 +7294 403 +7295 403 +7296 402 +7297 403 +7298 403 +7299 402 +7300 403 +7301 403 +7302 402 +7303 403 +7304 403 +7305 402 +7306 403 +7307 403 +7308 402 +7309 403 +7310 403 +7311 402 +7312 403 +7313 403 +7314 402 +7315 403 +7316 403 +7317 402 +7318 403 +7319 403 +7320 402 +7321 403 +7322 403 +7323 402 +7324 403 +7325 403 +7326 402 +7327 403 +7328 403 +7329 402 +7330 403 +7331 403 +7332 402 +7333 403 +7334 403 +7335 402 +7336 403 +7337 403 +7338 402 +7339 403 +7340 403 +7341 402 +7342 403 +7343 403 +7344 402 +7345 403 +7346 403 +7347 402 +7348 403 +7349 403 +7350 402 +7351 403 +7352 403 +7353 402 +7354 403 +7355 403 +7356 402 +7357 403 +7358 403 +7359 402 +7360 403 +7361 403 +7362 402 +7363 403 +7364 403 +7365 402 +7366 403 +7367 403 +7368 402 +7369 403 +7370 403 +7371 402 +7372 403 +7373 403 +7374 402 +7375 403 +7376 403 +7377 402 +7378 403 +7379 403 +7380 402 +7381 403 +7382 403 +7383 402 +7384 403 +7385 403 +7386 402 +7387 403 +7388 403 +7389 402 +7390 403 +7391 403 +7392 402 +7393 403 +7394 403 +7395 402 +7396 403 +7397 403 +7398 402 +7399 403 +7400 403 +7401 402 +7402 403 +7403 403 +7404 402 +7405 403 +7406 403 +7407 402 +7408 403 +7409 403 +7410 402 +7411 403 +7412 403 +7413 402 +7414 403 +7415 403 +7416 402 +7417 403 +7418 403 +7419 402 +7420 403 +7421 403 +7422 402 +7423 403 +7424 403 +7425 402 +7426 403 +7427 403 +7428 402 +7429 403 +7430 403 +7431 402 +7432 403 +7433 403 +7434 402 +7435 403 +7436 403 +7437 402 +7438 403 +7439 403 +7440 402 +7441 403 +7442 403 +7443 402 +7444 403 +7445 403 +7446 402 +7447 403 +7448 403 +7449 402 +7450 403 +7451 403 +7452 402 +7453 403 +7454 403 +7455 402 +7456 403 +7457 403 +7458 402 +7459 403 +7460 403 +7461 402 +7462 403 +7463 403 +7464 402 +7465 403 +7466 403 +7467 402 +7468 403 +7469 403 +7470 402 +7471 403 +7472 403 +7473 402 +7474 403 +7475 403 +7476 402 +7477 403 +7478 403 +7479 402 +7480 403 +7481 403 +7482 402 +7483 403 +7484 403 +7485 402 +7486 403 +7487 403 +7488 402 +7489 403 +7490 403 +7491 402 +7492 403 +7493 403 +7494 402 +7495 403 +7496 403 +7497 402 +7498 403 +7499 403 +7500 402 +7501 403 +7502 403 +7503 402 +7504 403 +7505 403 +7506 402 +7507 403 +7508 403 +7509 402 +7510 403 +7511 403 +7512 402 +7513 403 +7514 403 +7515 402 +7516 403 +7517 403 +7518 402 +7519 403 +7520 403 +7521 402 +7522 403 +7523 403 +7524 402 +7525 403 +7526 403 +7527 402 +7528 403 +7529 403 +7530 402 +7531 403 +7532 403 +7533 402 +7534 403 +7535 403 +7536 402 +7537 403 +7538 403 +7539 402 +7540 403 +7541 403 +7542 402 +7543 403 +7544 403 +7545 402 +7546 403 +7547 403 +7548 402 +7549 403 +7550 403 +7551 402 +7552 403 +7553 403 +7554 402 +7555 403 +7556 403 +7557 402 +7558 403 +7559 403 +7560 402 +7561 403 +7562 403 +7563 402 +7564 403 +7565 403 +7566 402 +7567 403 +7568 403 +7569 402 +7570 403 +7571 403 +7572 402 +7573 403 +7574 403 +7575 402 +7576 403 +7577 403 +7578 402 +7579 403 +7580 403 +7581 402 +7582 403 +7583 403 +7584 402 +7585 403 +7586 403 +7587 402 +7588 403 +7589 403 +7590 402 +7591 403 +7592 403 +7593 402 +7594 403 +7595 403 +7596 402 +7597 403 +7598 403 +7599 402 +7600 403 +7601 403 +7602 402 +7603 403 +7604 403 +7605 402 +7606 403 +7607 403 +7608 402 +7609 403 +7610 403 +7611 402 +7612 403 +7613 403 +7614 402 +7615 403 +7616 403 +7617 402 +7618 403 +7619 403 +7620 402 +7621 403 +7622 403 +7623 402 +7624 403 +7625 403 +7626 402 +7627 403 +7628 403 +7629 402 +7630 403 +7631 403 +7632 402 +7633 403 +7634 403 +7635 402 +7636 403 +7637 403 +7638 402 +7639 403 +7640 403 +7641 402 +7642 403 +7643 403 +7644 402 +7645 403 +7646 403 +7647 402 +7648 403 +7649 403 +7650 402 +7651 403 +7652 403 +7653 402 +7654 403 +7655 403 +7656 402 +7657 403 +7658 403 +7659 402 +7660 403 +7661 403 +7662 402 +7663 403 +7664 403 +7665 402 +7666 403 +7667 403 +7668 402 +7669 403 +7670 403 +7671 402 +7672 403 +7673 403 +7674 402 +7675 403 +7676 403 +7677 402 +7678 403 +7679 403 +7680 402 +7681 403 +7682 403 +7683 402 +7684 403 +7685 403 +7686 402 +7687 403 +7688 403 +7689 402 +7690 403 +7691 403 +7692 402 +7693 403 +7694 403 +7695 402 +7696 403 +7697 403 +7698 402 +7699 403 +7700 403 +7701 402 +7702 403 +7703 403 +7704 402 +7705 403 +7706 403 +7707 402 +7708 403 +7709 403 +7710 402 +7711 403 +7712 403 +7713 402 +7714 403 +7715 403 +7716 402 +7717 403 +7718 403 +7719 402 +7720 403 +7721 403 +7722 402 +7723 403 +7724 403 +7725 402 +7726 403 +7727 403 +7728 402 +7729 403 +7730 403 +7731 402 +7732 403 +7733 403 +7734 402 +7735 403 +7736 403 +7737 402 +7738 403 +7739 403 +7740 402 +7741 403 +7742 403 +7743 402 +7744 403 +7745 403 +7746 402 +7747 403 +7748 403 +7749 402 +7750 403 +7751 403 +7752 402 +7753 403 +7754 403 +7755 402 +7756 403 +7757 403 +7758 402 +7759 403 +7760 403 +7761 402 +7762 403 +7763 403 +7764 402 +7765 403 +7766 403 +7767 402 +7768 403 +7769 403 +7770 402 +7771 403 +7772 403 +7773 402 +7774 403 +7775 403 +7776 402 +7777 403 +7778 403 +7779 402 +7780 403 +7781 403 +7782 402 +7783 403 +7784 403 +7785 402 +7786 403 +7787 403 +7788 402 +7789 403 +7790 403 +7791 402 +7792 403 +7793 403 +7794 402 +7795 403 +7796 403 +7797 402 +7798 403 +7799 403 +7800 402 +7801 403 +7802 403 +7803 402 +7804 403 +7805 403 +7806 402 +7807 403 +7808 403 +7809 402 +7810 403 +7811 403 +7812 402 +7813 403 +7814 403 +7815 402 +7816 403 +7817 403 +7818 402 +7819 403 +7820 403 +7821 402 +7822 403 +7823 403 +7824 402 +7825 403 +7826 403 +7827 402 +7828 403 +7829 403 +7830 402 +7831 403 +7832 403 +7833 402 +7834 403 +7835 403 +7836 402 +7837 403 +7838 403 +7839 402 +7840 403 +7841 403 +7842 402 +7843 403 +7844 403 +7845 402 +7846 403 +7847 403 +7848 402 +7849 403 +7850 403 +7851 402 +7852 403 +7853 403 +7854 402 +7855 403 +7856 403 +7857 402 +7858 403 +7859 403 +7860 402 +7861 403 +7862 403 +7863 402 +7864 403 +7865 403 +7866 402 +7867 403 +7868 403 +7869 402 +7870 403 +7871 403 +7872 402 +7873 403 +7874 403 +7875 402 +7876 403 +7877 403 +7878 402 +7879 403 +7880 403 +7881 402 +7882 403 +7883 403 +7884 402 +7885 403 +7886 403 +7887 402 +7888 403 +7889 403 +7890 402 +7891 403 +7892 403 +7893 402 +7894 403 +7895 403 +7896 402 +7897 403 +7898 403 +7899 402 +7900 403 +7901 403 +7902 402 +7903 403 +7904 403 +7905 402 +7906 403 +7907 403 +7908 402 +7909 403 +7910 403 +7911 402 +7912 403 +7913 403 +7914 402 +7915 403 +7916 403 +7917 402 +7918 403 +7919 403 +7920 402 +7921 403 +7922 403 +7923 402 +7924 403 +7925 403 +7926 402 +7927 403 +7928 403 +7929 402 +7930 403 +7931 403 +7932 402 +7933 403 +7934 403 +7935 402 +7936 403 +7937 403 +7938 402 +7939 403 +7940 403 +7941 402 +7942 403 +7943 403 +7944 402 +7945 403 +7946 403 +7947 402 +7948 403 +7949 403 +7950 402 +7951 403 +7952 403 +7953 402 +7954 403 +7955 403 +7956 402 +7957 403 +7958 403 +7959 402 +7960 403 +7961 403 +7962 402 +7963 403 +7964 403 +7965 402 +7966 403 +7967 403 +7968 402 +7969 403 +7970 403 +7971 402 +7972 403 +7973 403 +7974 402 +7975 403 +7976 403 +7977 402 +7978 403 +7979 403 +7980 402 +7981 403 +7982 403 +7983 402 +7984 403 +7985 403 +7986 402 +7987 403 +7988 403 +7989 402 +7990 403 +7991 403 +7992 402 +7993 403 +7994 403 +7995 402 +7996 403 +7997 403 +7998 402 +7999 403 +8000 403 +8001 402 +8002 403 +8003 403 +8004 402 +8005 403 +8006 403 +8007 402 +8008 403 +8009 403 +8010 402 +8011 403 +8012 403 +8013 402 +8014 403 +8015 403 +8016 402 +8017 403 +8018 403 +8019 402 +8020 403 +8021 403 +8022 402 +8023 403 +8024 403 +8025 402 +8026 403 +8027 403 +8028 402 +8029 403 +8030 403 +8031 402 +8032 403 +8033 403 +8034 402 +8035 403 +8036 403 +8037 402 +8038 403 +8039 403 +8040 402 +8041 403 +8042 403 +8043 402 +8044 403 +8045 403 +8046 402 +8047 403 +8048 403 +8049 402 +8050 403 +8051 403 +8052 402 +8053 403 +8054 403 +8055 402 +8056 403 +8057 403 +8058 402 +8059 403 +8060 403 +8061 402 +8062 403 +8063 403 +8064 402 +8065 403 +8066 403 +8067 402 +8068 403 +8069 403 +8070 402 +8071 403 +8072 403 +8073 402 +8074 403 +8075 403 +8076 402 +8077 403 +8078 403 +8079 402 +8080 403 +8081 403 +8082 402 +8083 403 +8084 403 +8085 402 +8086 403 +8087 403 +8088 402 +8089 403 +8090 403 +8091 402 +8092 403 +8093 403 +8094 402 +8095 403 +8096 403 +8097 402 +8098 403 +8099 403 +8100 402 +8101 403 +8102 403 +8103 402 +8104 403 +8105 403 +8106 402 +8107 403 +8108 403 +8109 402 +8110 403 +8111 403 +8112 402 +8113 403 +8114 403 +8115 402 +8116 403 +8117 403 +8118 402 +8119 403 +8120 403 +8121 402 +8122 403 +8123 403 +8124 402 +8125 403 +8126 403 +8127 402 +8128 403 +8129 403 +8130 402 +8131 403 +8132 403 +8133 402 +8134 403 +8135 403 +8136 402 +8137 403 +8138 403 +8139 402 +8140 403 +8141 403 +8142 402 +8143 403 +8144 403 +8145 402 +8146 403 +8147 403 +8148 402 +8149 403 +8150 403 +8151 402 +8152 403 +8153 403 +8154 402 +8155 403 +8156 403 +8157 402 +8158 403 +8159 403 +8160 402 +8161 403 +8162 403 +8163 402 +8164 403 +8165 403 +8166 402 +8167 403 +8168 403 +8169 402 +8170 403 +8171 403 +8172 402 +8173 403 +8174 403 +8175 402 +8176 403 +8177 403 +8178 402 +8179 403 +8180 403 +8181 402 +8182 403 +8183 403 +8184 402 +8185 403 +8186 403 +8187 402 +8188 403 +8189 403 +8190 402 +8191 403 +8192 403 +8193 402 +8194 403 +8195 403 +8196 402 +8197 403 +8198 403 +8199 402 +8200 403 +8201 403 +8202 402 +8203 403 +8204 403 +8205 402 +8206 403 +8207 403 +8208 402 +8209 403 +8210 403 +8211 402 +8212 403 +8213 403 +8214 402 +8215 403 +8216 403 +8217 402 +8218 403 +8219 403 +8220 402 +8221 403 +8222 403 +8223 402 +8224 403 +8225 403 +8226 402 +8227 403 +8228 403 +8229 402 +8230 403 +8231 403 +8232 402 +8233 403 +8234 403 +8235 402 +8236 403 +8237 403 +8238 402 +8239 403 +8240 403 +8241 402 +8242 403 +8243 403 +8244 402 +8245 403 +8246 403 +8247 402 +8248 403 +8249 403 +8250 402 +8251 403 +8252 403 +8253 402 +8254 403 +8255 403 +8256 402 +8257 403 +8258 403 +8259 402 +8260 403 +8261 403 +8262 402 +8263 403 +8264 403 +8265 402 +8266 403 +8267 403 +8268 402 +8269 403 +8270 403 +8271 402 +8272 403 +8273 403 +8274 402 +8275 403 +8276 403 +8277 402 +8278 403 +8279 403 +8280 402 +8281 403 +8282 403 +8283 402 +8284 403 +8285 403 +8286 402 +8287 403 +8288 403 +8289 402 +8290 403 +8291 403 +8292 402 +8293 403 +8294 403 +8295 402 +8296 403 +8297 403 +8298 402 +8299 403 +8300 403 +8301 402 +8302 403 +8303 403 +8304 402 +8305 403 +8306 403 +8307 402 +8308 403 +8309 403 +8310 402 +8311 403 +8312 403 +8313 402 +8314 403 +8315 403 +8316 402 +8317 403 +8318 403 +8319 402 +8320 403 +8321 403 +8322 402 +8323 403 +8324 403 +8325 402 +8326 403 +8327 403 +8328 402 +8329 403 +8330 403 +8331 402 +8332 403 +8333 403 +8334 402 +8335 403 +8336 403 +8337 402 +8338 403 +8339 403 +8340 402 +8341 403 +8342 403 +8343 402 +8344 403 +8345 403 +8346 402 +8347 403 +8348 403 +8349 402 +8350 403 +8351 403 +8352 402 +8353 403 +8354 403 +8355 402 +8356 403 +8357 403 +8358 402 +8359 403 +8360 403 +8361 402 +8362 403 +8363 403 +8364 402 +8365 403 +8366 403 +8367 402 +8368 403 +8369 403 +8370 402 +8371 403 +8372 403 +8373 402 +8374 403 +8375 403 +8376 402 +8377 403 +8378 403 +8379 402 +8380 403 +8381 403 +8382 402 +8383 403 +8384 403 +8385 402 +8386 403 +8387 403 +8388 402 +8389 403 +8390 403 +8391 402 +8392 403 +8393 403 +8394 402 +8395 403 +8396 403 +8397 402 +8398 403 +8399 403 +8400 402 +8401 403 +8402 403 +8403 402 +8404 403 +8405 403 +8406 402 +8407 403 +8408 403 +8409 402 +8410 403 +8411 403 +8412 402 +8413 403 +8414 403 +8415 402 +8416 403 +8417 403 +8418 402 +8419 403 +8420 403 +8421 402 +8422 403 +8423 403 +8424 402 +8425 403 +8426 403 +8427 402 +8428 403 +8429 403 +8430 402 +8431 403 +8432 403 +8433 402 +8434 403 +8435 403 +8436 402 +8437 403 +8438 403 +8439 402 +8440 403 +8441 403 +8442 402 +8443 403 +8444 403 +8445 402 +8446 403 +8447 403 +8448 402 +8449 403 +8450 403 +8451 402 +8452 403 +8453 403 +8454 402 +8455 403 +8456 403 +8457 402 +8458 403 +8459 403 +8460 402 +8461 403 +8462 403 +8463 402 +8464 403 +8465 403 +8466 402 +8467 403 +8468 403 +8469 402 +8470 403 +8471 403 +8472 402 +8473 403 +8474 403 +8475 402 +8476 403 +8477 403 +8478 402 +8479 403 +8480 403 +8481 402 +8482 403 +8483 403 +8484 402 +8485 403 +8486 403 +8487 402 +8488 403 +8489 403 +8490 402 +8491 403 +8492 403 +8493 402 +8494 403 +8495 403 +8496 402 +8497 403 +8498 403 +8499 402 +8500 403 +8501 403 +8502 402 +8503 403 +8504 403 +8505 402 +8506 403 +8507 403 +8508 402 +8509 403 +8510 403 +8511 402 +8512 403 +8513 403 +8514 402 +8515 403 +8516 403 +8517 402 +8518 403 +8519 403 +8520 402 +8521 403 +8522 403 +8523 402 +8524 403 +8525 403 +8526 402 +8527 403 +8528 403 +8529 402 +8530 403 +8531 403 +8532 402 +8533 403 +8534 403 +8535 402 +8536 403 +8537 403 +8538 402 +8539 403 +8540 403 +8541 402 +8542 403 +8543 403 +8544 402 +8545 403 +8546 403 +8547 402 +8548 403 +8549 403 +8550 402 +8551 403 +8552 403 +8553 402 +8554 403 +8555 403 +8556 402 +8557 403 +8558 403 +8559 402 +8560 403 +8561 403 +8562 402 +8563 403 +8564 403 +8565 402 +8566 403 +8567 403 +8568 402 +8569 403 +8570 403 +8571 402 +8572 403 +8573 403 +8574 402 +8575 403 +8576 403 +8577 402 +8578 403 +8579 403 +8580 402 +8581 403 +8582 403 +8583 402 +8584 403 +8585 403 +8586 402 +8587 403 +8588 403 +8589 402 +8590 403 +8591 403 +8592 402 +8593 403 +8594 403 +8595 402 +8596 403 +8597 403 +8598 402 +8599 403 +8600 403 +8601 402 +8602 403 +8603 403 +8604 402 +8605 403 +8606 403 +8607 402 +8608 403 +8609 403 +8610 402 +8611 403 +8612 403 +8613 402 +8614 403 +8615 403 +8616 402 +8617 403 +8618 403 +8619 402 +8620 403 +8621 403 +8622 402 +8623 403 +8624 403 +8625 402 +8626 403 +8627 403 +8628 402 +8629 403 +8630 403 +8631 402 +8632 403 +8633 403 +8634 402 +8635 403 +8636 403 +8637 402 +8638 403 +8639 403 +8640 402 +8641 403 +8642 403 +8643 402 +8644 403 +8645 403 +8646 402 +8647 403 +8648 403 +8649 402 +8650 403 +8651 403 +8652 402 +8653 403 +8654 403 +8655 402 +8656 403 +8657 403 +8658 402 +8659 403 +8660 403 +8661 402 +8662 403 +8663 403 +8664 402 +8665 403 +8666 403 +8667 402 +8668 403 +8669 403 +8670 402 +8671 403 +8672 403 +8673 402 +8674 403 +8675 403 +8676 402 +8677 403 +8678 403 +8679 402 +8680 403 +8681 403 +8682 402 +8683 403 +8684 403 +8685 402 +8686 403 +8687 403 +8688 402 +8689 403 +8690 403 +8691 402 +8692 403 +8693 403 +8694 402 +8695 403 +8696 403 +8697 402 +8698 403 +8699 403 +8700 402 +8701 403 +8702 403 +8703 402 +8704 403 +8705 403 +8706 402 +8707 403 +8708 403 +8709 402 +8710 403 +8711 403 +8712 402 +8713 403 +8714 403 +8715 402 +8716 403 +8717 403 +8718 402 +8719 403 +8720 403 +8721 402 +8722 403 +8723 403 +8724 402 +8725 403 +8726 403 +8727 402 +8728 403 +8729 403 +8730 402 +8731 403 +8732 403 +8733 402 +8734 403 +8735 403 +8736 402 +8737 403 +8738 403 +8739 402 +8740 403 +8741 403 +8742 402 +8743 403 +8744 403 +8745 402 +8746 403 +8747 403 +8748 402 +8749 403 +8750 403 +8751 402 +8752 403 +8753 403 +8754 402 +8755 403 +8756 403 +8757 402 +8758 403 +8759 403 +8760 402 +8761 403 +8762 403 +8763 402 +8764 403 +8765 403 +8766 402 +8767 403 +8768 403 +8769 402 +8770 403 +8771 403 +8772 402 +8773 403 +8774 403 +8775 402 +8776 403 +8777 403 +8778 402 +8779 403 +8780 403 +8781 402 +8782 403 +8783 403 +8784 402 +8785 403 +8786 403 +8787 402 +8788 403 +8789 403 +8790 402 +8791 403 +8792 403 +8793 402 +8794 403 +8795 403 +8796 402 +8797 403 +8798 403 +8799 402 +8800 403 +8801 403 +8802 402 +8803 403 +8804 403 +8805 402 +8806 403 +8807 403 +8808 402 +8809 403 +8810 403 +8811 402 +8812 403 +8813 403 +8814 402 +8815 403 +8816 403 +8817 402 +8818 403 +8819 403 +8820 402 +8821 403 +8822 403 +8823 402 +8824 403 +8825 403 +8826 402 +8827 403 +8828 403 +8829 402 +8830 403 +8831 403 +8832 402 +8833 403 +8834 403 +8835 402 +8836 403 +8837 403 +8838 402 +8839 403 +8840 403 +8841 402 +8842 403 +8843 403 +8844 402 +8845 403 +8846 403 +8847 402 +8848 403 +8849 403 +8850 402 +8851 403 +8852 403 +8853 402 +8854 403 +8855 403 +8856 402 +8857 403 +8858 403 +8859 402 +8860 403 +8861 403 +8862 402 +8863 403 +8864 403 +8865 402 +8866 403 +8867 403 +8868 402 +8869 403 +8870 403 +8871 402 +8872 403 +8873 403 +8874 402 +8875 403 +8876 403 +8877 402 +8878 403 +8879 403 +8880 402 +8881 403 +8882 403 +8883 402 +8884 403 +8885 403 +8886 402 +8887 403 +8888 403 +8889 402 +8890 403 +8891 403 +8892 402 +8893 403 +8894 403 +8895 402 +8896 403 +8897 403 +8898 402 +8899 403 +8900 403 +8901 402 +8902 403 +8903 403 +8904 402 +8905 403 +8906 403 +8907 402 +8908 403 +8909 403 +8910 402 +8911 403 +8912 403 +8913 402 +8914 403 +8915 403 +8916 402 +8917 403 +8918 403 +8919 402 +8920 403 +8921 403 +8922 402 +8923 403 +8924 403 +8925 402 +8926 403 +8927 403 +8928 402 +8929 403 +8930 403 +8931 402 +8932 403 +8933 403 +8934 402 +8935 403 +8936 403 +8937 402 +8938 403 +8939 403 +8940 402 +8941 403 +8942 403 +8943 402 +8944 403 +8945 403 +8946 402 +8947 403 +8948 403 +8949 402 +8950 403 +8951 403 +8952 402 +8953 403 +8954 403 +8955 402 +8956 403 +8957 403 +8958 402 +8959 403 +8960 403 +8961 402 +8962 403 +8963 403 +8964 402 +8965 403 +8966 403 +8967 402 +8968 403 +8969 403 +8970 402 +8971 403 +8972 403 +8973 402 +8974 403 +8975 403 +8976 402 +8977 403 +8978 403 +8979 402 +8980 403 +8981 403 +8982 402 +8983 403 +8984 403 +8985 402 +8986 403 +8987 403 +8988 402 +8989 403 +8990 403 +8991 402 +8992 403 +8993 403 +8994 402 +8995 403 +8996 403 +8997 402 +8998 403 +8999 403 +9000 402 +9001 403 +9002 403 +9003 402 +9004 403 +9005 403 +9006 402 +9007 403 +9008 403 +9009 402 +9010 403 +9011 403 +9012 402 +9013 403 +9014 403 +9015 402 +9016 403 +9017 403 +9018 402 +9019 403 +9020 403 +9021 402 +9022 403 +9023 403 +9024 402 +9025 403 +9026 403 +9027 402 +9028 403 +9029 403 +9030 402 +9031 403 +9032 403 +9033 402 +9034 403 +9035 403 +9036 402 +9037 403 +9038 403 +9039 402 +9040 403 +9041 403 +9042 402 +9043 403 +9044 403 +9045 402 +9046 403 +9047 403 +9048 402 +9049 403 +9050 403 +9051 402 +9052 403 +9053 403 +9054 402 +9055 403 +9056 403 +9057 402 +9058 403 +9059 403 +9060 402 +9061 403 +9062 403 +9063 402 +9064 403 +9065 403 +9066 402 +9067 403 +9068 403 +9069 402 +9070 403 +9071 403 +9072 402 +9073 403 +9074 403 +9075 402 +9076 403 +9077 403 +9078 402 +9079 403 +9080 403 +9081 402 +9082 403 +9083 403 +9084 402 +9085 403 +9086 403 +9087 402 +9088 403 +9089 403 +9090 402 +9091 403 +9092 403 +9093 402 +9094 403 +9095 403 +9096 402 +9097 403 +9098 403 +9099 402 +9100 403 +9101 403 +9102 402 +9103 403 +9104 403 +9105 402 +9106 403 +9107 403 +9108 402 +9109 403 +9110 403 +9111 402 +9112 403 +9113 403 +9114 402 +9115 403 +9116 403 +9117 402 +9118 403 +9119 403 +9120 402 +9121 403 +9122 403 +9123 402 +9124 403 +9125 403 +9126 402 +9127 403 +9128 403 +9129 402 +9130 403 +9131 403 +9132 402 +9133 403 +9134 403 +9135 402 +9136 403 +9137 403 +9138 402 +9139 403 +9140 403 +9141 402 +9142 403 +9143 403 +9144 402 +9145 403 +9146 403 +9147 402 +9148 403 +9149 403 +9150 402 +9151 403 +9152 403 +9153 402 +9154 403 +9155 403 +9156 402 +9157 403 +9158 403 +9159 402 +9160 403 +9161 403 +9162 402 +9163 403 +9164 403 +9165 402 +9166 403 +9167 403 +9168 402 +9169 403 +9170 403 +9171 402 +9172 403 +9173 403 +9174 402 +9175 403 +9176 403 +9177 402 +9178 403 +9179 403 +9180 402 +9181 403 +9182 403 +9183 402 +9184 403 +9185 403 +9186 402 +9187 403 +9188 403 +9189 402 +9190 403 +9191 403 +9192 402 +9193 403 +9194 403 +9195 402 +9196 403 +9197 403 +9198 402 +9199 403 +9200 403 +9201 402 +9202 403 +9203 403 +9204 402 +9205 403 +9206 403 +9207 402 +9208 403 +9209 403 +9210 402 +9211 403 +9212 403 +9213 402 +9214 403 +9215 403 +9216 402 +9217 403 +9218 403 +9219 402 +9220 403 +9221 403 +9222 402 +9223 403 +9224 403 +9225 402 +9226 403 +9227 403 +9228 402 +9229 403 +9230 403 +9231 402 +9232 403 +9233 403 +9234 402 +9235 403 +9236 403 +9237 402 +9238 403 +9239 403 +9240 402 +9241 403 +9242 403 +9243 402 +9244 403 +9245 403 +9246 402 +9247 403 +9248 403 +9249 402 +9250 403 +9251 403 +9252 402 +9253 403 +9254 403 +9255 402 +9256 403 +9257 403 +9258 402 +9259 403 +9260 403 +9261 402 +9262 403 +9263 403 +9264 402 +9265 403 +9266 403 +9267 402 +9268 403 +9269 403 +9270 402 +9271 403 +9272 403 +9273 402 +9274 403 +9275 403 +9276 402 +9277 403 +9278 403 +9279 402 +9280 403 +9281 403 +9282 402 +9283 403 +9284 403 +9285 402 +9286 403 +9287 403 +9288 402 +9289 403 +9290 403 +9291 402 +9292 403 +9293 403 +9294 402 +9295 403 +9296 403 +9297 402 +9298 403 +9299 403 +9300 402 +9301 403 +9302 403 +9303 402 +9304 403 +9305 403 +9306 402 +9307 403 +9308 403 +9309 402 +9310 403 +9311 403 +9312 402 +9313 403 +9314 403 +9315 402 +9316 403 +9317 403 +9318 402 +9319 403 +9320 403 +9321 402 +9322 403 +9323 403 +9324 402 +9325 403 +9326 403 +9327 402 +9328 403 +9329 403 +9330 402 +9331 403 +9332 403 +9333 402 +9334 403 +9335 403 +9336 402 +9337 403 +9338 403 +9339 402 +9340 403 +9341 403 +9342 402 +9343 403 +9344 403 +9345 402 +9346 403 +9347 403 +9348 402 +9349 403 +9350 403 +9351 402 +9352 403 +9353 403 +9354 402 +9355 403 +9356 403 +9357 402 +9358 403 +9359 403 +9360 402 +9361 403 +9362 403 +9363 402 +9364 403 +9365 403 +9366 402 +9367 403 +9368 403 +9369 402 +9370 403 +9371 403 +9372 402 +9373 403 +9374 403 +9375 402 +9376 403 +9377 403 +9378 402 +9379 403 +9380 403 +9381 402 +9382 403 +9383 403 +9384 402 +9385 403 +9386 403 +9387 402 +9388 403 +9389 403 +9390 402 +9391 403 +9392 403 +9393 402 +9394 403 +9395 403 +9396 402 +9397 403 +9398 403 +9399 402 +9400 403 +9401 403 +9402 402 +9403 403 +9404 403 +9405 402 +9406 403 +9407 403 +9408 402 +9409 403 +9410 403 +9411 402 +9412 403 +9413 403 +9414 402 +9415 403 +9416 403 +9417 402 +9418 403 +9419 403 +9420 402 +9421 403 +9422 403 +9423 402 +9424 403 +9425 403 +9426 402 +9427 403 +9428 403 +9429 402 +9430 403 +9431 403 +9432 402 +9433 403 +9434 403 +9435 402 +9436 403 +9437 403 +9438 402 +9439 403 +9440 403 +9441 402 +9442 403 +9443 403 +9444 402 +9445 403 +9446 403 +9447 402 +9448 403 +9449 403 +9450 402 +9451 403 +9452 403 +9453 402 +9454 403 +9455 403 +9456 402 +9457 403 +9458 403 +9459 402 +9460 403 +9461 403 +9462 402 +9463 403 +9464 403 +9465 402 +9466 403 +9467 403 +9468 402 +9469 403 +9470 403 +9471 402 +9472 403 +9473 403 +9474 402 +9475 403 +9476 403 +9477 402 +9478 403 +9479 403 +9480 402 +9481 403 +9482 403 +9483 402 +9484 403 +9485 403 +9486 402 +9487 403 +9488 403 +9489 402 +9490 403 +9491 403 +9492 402 +9493 403 +9494 403 +9495 402 +9496 403 +9497 403 +9498 402 +9499 403 +9500 403 +9501 402 +9502 403 +9503 403 +9504 402 +9505 403 +9506 403 +9507 402 +9508 403 +9509 403 +9510 402 +9511 403 +9512 403 +9513 402 +9514 403 +9515 403 +9516 402 +9517 403 +9518 403 +9519 402 +9520 403 +9521 403 +9522 402 +9523 403 +9524 403 +9525 402 +9526 403 +9527 403 +9528 402 +9529 403 +9530 403 +9531 402 +9532 403 +9533 403 +9534 402 +9535 403 +9536 403 +9537 402 +9538 403 +9539 403 +9540 402 +9541 403 +9542 403 +9543 402 +9544 403 +9545 403 +9546 402 +9547 403 +9548 403 +9549 402 +9550 403 +9551 403 +9552 402 +9553 403 +9554 403 +9555 402 +9556 403 +9557 403 +9558 402 +9559 403 +9560 403 +9561 402 +9562 403 +9563 403 +9564 402 +9565 403 +9566 403 +9567 402 +9568 403 +9569 403 +9570 402 +9571 403 +9572 403 +9573 402 +9574 403 +9575 403 +9576 402 +9577 403 +9578 403 +9579 402 +9580 403 +9581 403 +9582 402 +9583 403 +9584 403 +9585 402 +9586 403 +9587 403 +9588 402 +9589 403 +9590 403 +9591 402 +9592 403 +9593 403 +9594 402 +9595 403 +9596 403 +9597 402 +9598 403 +9599 403 +9600 402 +9601 403 +9602 403 +9603 402 +9604 403 +9605 403 +9606 402 +9607 403 +9608 403 +9609 402 +9610 403 +9611 403 +9612 402 +9613 403 +9614 403 +9615 402 +9616 403 +9617 403 +9618 402 +9619 403 +9620 403 +9621 402 +9622 403 +9623 403 +9624 402 +9625 403 +9626 403 +9627 402 +9628 403 +9629 403 +9630 402 +9631 403 +9632 403 +9633 402 +9634 403 +9635 403 +9636 402 +9637 403 +9638 403 +9639 402 +9640 403 +9641 403 +9642 402 +9643 403 +9644 403 +9645 402 +9646 403 +9647 403 +9648 402 +9649 403 +9650 403 +9651 402 +9652 403 +9653 403 +9654 402 +9655 403 +9656 403 +9657 402 +9658 403 +9659 403 +9660 402 +9661 403 +9662 403 +9663 402 +9664 403 +9665 403 +9666 402 +9667 403 +9668 403 +9669 402 +9670 403 +9671 403 +9672 402 +9673 403 +9674 403 +9675 402 +9676 403 +9677 403 +9678 402 +9679 403 +9680 403 +9681 402 +9682 403 +9683 403 +9684 402 +9685 403 +9686 403 +9687 402 +9688 403 +9689 403 +9690 402 +9691 403 +9692 403 +9693 402 +9694 403 +9695 403 +9696 402 +9697 403 +9698 403 +9699 402 +9700 403 +9701 403 +9702 402 +9703 403 +9704 403 +9705 402 +9706 403 +9707 403 +9708 402 +9709 403 +9710 403 +9711 402 +9712 403 +9713 403 +9714 402 +9715 403 +9716 403 +9717 402 +9718 403 +9719 403 +9720 402 +9721 403 +9722 403 +9723 402 +9724 403 +9725 403 +9726 402 +9727 403 +9728 403 +9729 402 +9730 403 +9731 403 +9732 402 +9733 403 +9734 403 +9735 402 +9736 403 +9737 403 diff --git a/examples/amoeba/data.water_box b/examples/amoeba/data.water_box new file mode 100644 index 0000000000..9881b4bce2 --- /dev/null +++ b/examples/amoeba/data.water_box @@ -0,0 +1,1980 @@ +LAMMPS data file created from Tinker watersmall.xyz and amoeba_watersmall.prm files + +648 atoms +432 bonds +216 angles +2 atom types +1 bond types +1 angle types +0 18.643 xlo xhi +0 18.643 ylo yhi +0 18.643 zlo zhi + +Masses + +1 15.995 +2 1.008 + +Atoms + +1 1 1 0 8.679662 7.087692 -0.696862 +2 1 2 0 7.809455 6.755792 -0.382259 +3 1 2 0 8.722232 6.814243 -1.617561 +4 2 1 0 -0.117313 8.244447 6.837616 +5 2 2 0 0.216892 7.895445 6.050027 +6 2 2 0 0.444268 7.826013 7.530196 +7 3 1 0 8.379057 -0.092611 6.814631 +8 3 2 0 9.340423 0.098069 6.734062 +9 3 2 0 7.939619 0.573676 6.269838 +10 4 1 0 6.589952 1.844323 -6.923167 +11 4 2 0 5.885429 2.402305 -6.717934 +12 4 2 0 6.181533 1.062747 -7.273678 +13 5 1 0 7.146600 5.753582 2.331517 +14 5 2 0 6.368123 6.126035 2.862678 +15 5 2 0 7.025018 6.294645 1.518196 +16 6 1 0 -2.426581 -8.504195 -2.504834 +17 6 2 0 -1.692063 -8.368252 -3.058292 +18 6 2 0 -2.793207 -7.602469 -2.403097 +19 7 1 0 -8.038375 -3.605589 2.303691 +20 7 2 0 -8.113753 -4.248127 3.018494 +21 7 2 0 -7.619392 -2.863004 2.709622 +22 8 1 0 -1.480631 8.244085 -8.272215 +23 8 2 0 -2.090204 8.687978 -7.676996 +24 8 2 0 -0.700878 8.823325 -8.322213 +25 9 1 0 -3.741962 -2.777830 -2.326319 +26 9 2 0 -4.620456 -2.444778 -2.390519 +27 9 2 0 -3.728921 -3.160952 -1.433101 +28 10 1 0 -6.467812 -5.265942 0.408263 +29 10 2 0 -6.585076 -4.796537 -0.413008 +30 10 2 0 -7.021252 -4.752640 1.007958 +31 11 1 0 9.273577 5.342431 4.055460 +32 11 2 0 8.645939 5.466500 4.837640 +33 11 2 0 8.741774 5.686149 3.302820 +34 12 1 0 1.830160 4.276731 -6.993499 +35 12 2 0 1.703275 5.223773 -6.703852 +36 12 2 0 2.408113 3.853447 -6.383339 +37 13 1 0 1.964382 6.832988 8.373101 +38 13 2 0 2.496135 7.215781 9.056298 +39 13 2 0 1.811283 5.905846 8.573539 +40 14 1 0 5.405568 4.388994 7.932737 +41 14 2 0 5.537380 3.438955 7.781311 +42 14 2 0 4.755156 4.734908 7.290617 +43 15 1 0 3.229998 2.928417 -1.090650 +44 15 2 0 3.931090 3.198265 -1.702769 +45 15 2 0 3.004438 3.708969 -0.493266 +46 16 1 0 7.462400 5.262829 6.131170 +47 16 2 0 8.025650 5.588493 6.881770 +48 16 2 0 6.935076 4.455766 6.325405 +49 17 1 0 -8.864042 7.023845 -6.659632 +50 17 2 0 -8.370939 6.372557 -7.141895 +51 17 2 0 -9.489800 7.315873 -7.293125 +52 18 1 0 -4.526299 3.549989 8.030031 +53 18 2 0 -5.169770 4.224127 7.731323 +54 18 2 0 -4.262096 3.801892 8.884875 +55 19 1 0 4.823286 -1.386218 4.038464 +56 19 2 0 5.493155 -0.669965 4.013081 +57 19 2 0 4.187463 -1.101832 3.338433 +58 20 1 0 -2.151150 -2.017060 -8.593685 +59 20 2 0 -2.475709 -2.320356 -7.783564 +60 20 2 0 -2.650484 -2.434614 -9.307384 +61 21 1 0 1.944893 4.933226 0.497910 +62 21 2 0 2.553221 5.263352 1.205303 +63 21 2 0 2.082534 5.590999 -0.202171 +64 22 1 0 -6.827006 -5.285917 -2.371899 +65 22 2 0 -7.405873 -6.022738 -2.075913 +66 22 2 0 -6.398443 -5.453726 -3.235054 +67 23 1 0 -8.538047 -7.577917 -1.688532 +68 23 2 0 -8.075591 -8.448260 -1.513455 +69 23 2 0 -9.389507 -7.836271 -2.051835 +70 24 1 0 -6.916556 -1.100882 -5.168782 +71 24 2 0 -6.365888 -1.659366 -5.746210 +72 24 2 0 -6.538885 -0.249374 -5.325993 +73 25 1 0 6.330290 -9.323893 -6.416630 +74 25 2 0 7.026026 -9.680578 -7.007727 +75 25 2 0 6.812488 -8.683594 -5.925799 +76 26 1 0 -2.424345 -5.918126 2.701855 +77 26 2 0 -1.613829 -5.486394 2.503024 +78 26 2 0 -3.144797 -5.307275 2.618121 +79 27 1 0 0.637202 -6.080457 5.849135 +80 27 2 0 0.892312 -6.092342 4.907709 +81 27 2 0 -0.339074 -5.838972 5.853292 +82 28 1 0 5.199216 -2.264918 -0.138343 +83 28 2 0 5.802838 -2.788698 -0.697536 +84 28 2 0 5.670340 -1.679393 0.462296 +85 29 1 0 0.510145 7.629450 4.054500 +86 29 2 0 -0.071135 8.146563 3.452959 +87 29 2 0 1.464962 7.740819 3.669172 +88 30 1 0 3.146724 8.895843 6.526257 +89 30 2 0 3.506091 8.599906 7.352942 +90 30 2 0 2.145729 8.929622 6.682029 +91 31 1 0 7.308541 -8.339335 -2.471342 +92 31 2 0 6.562127 -8.180601 -3.062803 +93 31 2 0 6.993025 -8.364954 -1.531235 +94 32 1 0 -7.530792 1.069683 4.989387 +95 32 2 0 -7.565406 1.971422 4.648636 +96 32 2 0 -7.938250 0.433547 4.370266 +97 33 1 0 4.452035 2.700609 -5.437815 +98 33 2 0 4.603326 3.058652 -4.551590 +99 33 2 0 4.386453 1.737004 -5.180419 +100 34 1 0 8.427922 -8.619286 1.784691 +101 34 2 0 8.340498 -8.005342 2.536225 +102 34 2 0 8.496720 -9.530562 2.174667 +103 35 1 0 -8.109456 1.753830 -3.096997 +104 35 2 0 -7.245287 1.827177 -2.721417 +105 35 2 0 -8.082178 1.783171 -4.059329 +106 36 1 0 2.776933 -5.701955 7.748213 +107 36 2 0 3.287974 -5.069688 7.233816 +108 36 2 0 1.987041 -5.817355 7.200131 +109 37 1 0 3.635171 -6.953519 5.339628 +110 37 2 0 3.353851 -7.592789 6.031367 +111 37 2 0 2.875801 -6.787975 4.740576 +112 38 1 0 6.888027 -4.169023 -1.800190 +113 38 2 0 7.559735 -4.813701 -2.004669 +114 38 2 0 6.603805 -3.759237 -2.626496 +115 39 1 0 -4.470837 -4.105640 3.415362 +116 39 2 0 -4.991607 -3.358538 3.140956 +117 39 2 0 -4.791764 -4.392214 4.254387 +118 40 1 0 8.282263 -0.462068 -2.560579 +119 40 2 0 8.776769 -1.293641 -2.335945 +120 40 2 0 8.760297 0.384816 -2.651128 +121 41 1 0 4.737236 1.616430 4.901115 +122 41 2 0 3.969692 2.168368 5.152631 +123 41 2 0 5.184651 2.148403 4.154746 +124 42 1 0 -3.497332 -5.781436 -2.202713 +125 42 2 0 -4.038857 -5.773824 -1.381680 +126 42 2 0 -4.152970 -6.012265 -2.829379 +127 43 1 0 -2.863989 -0.259334 -1.857006 +128 43 2 0 -2.132201 -0.027953 -1.174211 +129 43 2 0 -2.873625 -1.224425 -1.874253 +130 44 1 0 1.138300 1.133100 -2.085899 +131 44 2 0 1.965506 1.503520 -1.725316 +132 44 2 0 0.420521 1.534440 -1.551356 +133 45 1 0 -0.561328 4.590705 -2.780017 +134 45 2 0 -0.061173 3.919356 -3.294128 +135 45 2 0 -0.082763 4.733898 -1.955602 +136 46 1 0 -6.423002 -1.705204 -2.528225 +137 46 2 0 -7.233989 -1.949552 -1.975418 +138 46 2 0 -6.678416 -1.321413 -3.351278 +139 47 1 0 -2.772100 2.552210 -0.672282 +140 47 2 0 -2.907489 3.483552 -0.385605 +141 47 2 0 -2.977127 2.592348 -1.635820 +142 48 1 0 6.708678 -4.852016 -8.379280 +143 48 2 0 6.593474 -5.094964 -7.447187 +144 48 2 0 6.582524 -5.591596 -8.966502 +145 49 1 0 -8.497001 -0.440284 2.803721 +146 49 2 0 -8.422350 0.331961 2.183451 +147 49 2 0 -9.377295 -0.756160 2.677026 +148 50 1 0 2.975383 -0.894970 6.060783 +149 50 2 0 2.093991 -0.995700 5.670129 +150 50 2 0 3.458832 -0.759248 5.263958 +151 51 1 0 -6.085023 -1.629620 7.970284 +152 51 2 0 -6.685848 -2.391830 7.820849 +153 51 2 0 -6.177296 -1.190584 8.835912 +154 52 1 0 -3.763523 -3.356777 8.285436 +155 52 2 0 -4.660650 -3.029414 8.406662 +156 52 2 0 -3.411834 -3.178947 7.431180 +157 53 1 0 -1.100120 -0.320162 0.375372 +158 53 2 0 -0.527013 -1.012183 0.128652 +159 53 2 0 -0.673226 0.288559 0.934677 +160 54 1 0 0.910209 -8.271802 1.411429 +161 54 2 0 0.158544 -8.759532 1.870895 +162 54 2 0 0.565924 -7.546113 0.944383 +163 55 1 0 1.554065 -6.468033 3.310872 +164 55 2 0 1.362455 -7.162802 2.722340 +165 55 2 0 1.616233 -5.622409 2.872854 +166 56 1 0 0.543127 -1.388652 4.886094 +167 56 2 0 0.110320 -0.665826 5.311239 +168 56 2 0 0.420366 -2.216367 5.267301 +169 57 1 0 1.100526 1.019490 -9.255318 +170 57 2 0 1.460815 0.575286 -8.484128 +171 57 2 0 0.265613 0.594128 -9.297750 +172 58 1 0 -1.842348 2.327827 -5.355326 +173 58 2 0 -1.572941 2.573139 -6.288125 +174 58 2 0 -2.216679 1.439934 -5.361006 +175 59 1 0 2.452307 -2.814686 -6.448759 +176 59 2 0 2.862295 -3.091668 -5.589336 +177 59 2 0 2.913920 -3.262923 -7.181510 +178 60 1 0 -2.207998 -3.112007 5.945795 +179 60 2 0 -1.262203 -3.125339 6.205467 +180 60 2 0 -2.228269 -2.421858 5.220629 +181 61 1 0 5.845471 5.020556 -6.836491 +182 61 2 0 5.557986 5.913737 -6.753889 +183 61 2 0 5.089998 4.459153 -6.661079 +184 62 1 0 -3.421643 4.865553 0.731755 +185 62 2 0 -3.965419 4.458452 1.478214 +186 62 2 0 -3.973445 4.958338 -0.044430 +187 63 1 0 -2.302950 -2.349717 2.112168 +188 63 2 0 -2.576438 -1.873492 2.873191 +189 63 2 0 -1.882868 -1.715106 1.503782 +190 64 1 0 0.305885 4.878766 3.791182 +191 64 2 0 0.299338 5.855407 4.097578 +192 64 2 0 1.169911 4.563497 4.030616 +193 65 1 0 2.925008 -3.664845 -3.607450 +194 65 2 0 3.015896 -3.916618 -2.644267 +195 65 2 0 2.353923 -2.889459 -3.518284 +196 66 1 0 1.111505 -4.070255 -9.085693 +197 66 2 0 2.084905 -4.227348 -9.180249 +198 66 2 0 0.897072 -4.902218 -8.740523 +199 67 1 0 -4.992929 -1.974219 -7.099668 +200 67 2 0 -5.173269 -1.186309 -7.673625 +201 67 2 0 -5.070893 -2.753273 -7.658821 +202 68 1 0 4.730983 1.478420 0.720986 +203 68 2 0 4.271686 1.988265 0.034225 +204 68 2 0 4.117413 0.788607 1.061818 +205 69 1 0 1.421583 -0.176666 -6.729105 +206 69 2 0 1.217660 0.394331 -5.978213 +207 69 2 0 1.948444 -0.877988 -6.400659 +208 70 1 0 -7.093223 -8.541193 4.116187 +209 70 2 0 -7.074252 -8.047477 3.242159 +210 70 2 0 -6.153142 -8.537148 4.455550 +211 71 1 0 8.382540 -6.460958 3.765735 +212 71 2 0 9.258625 -6.141972 4.060763 +213 71 2 0 7.637364 -6.217910 4.407852 +214 72 1 0 -4.320241 4.037137 3.297092 +215 72 2 0 -3.750151 4.141786 4.105470 +216 72 2 0 -5.172925 4.455578 3.488906 +217 73 1 0 5.581877 1.781994 7.505132 +218 73 2 0 5.017196 1.139584 8.120950 +219 73 2 0 5.330781 1.591217 6.595286 +220 74 1 0 -0.734443 1.125031 4.884666 +221 74 2 0 -0.239224 1.540322 4.142070 +222 74 2 0 -0.961628 1.783437 5.554548 +223 75 1 0 6.831005 -9.249970 4.497165 +224 75 2 0 6.836746 -9.068011 5.427146 +225 75 2 0 7.668067 -9.652510 4.249957 +226 76 1 0 2.714055 -3.677581 1.962003 +227 76 2 0 3.333432 -3.851775 2.663540 +228 76 2 0 3.095021 -3.978526 1.102566 +229 77 1 0 -1.364034 -5.762724 -5.514747 +230 77 2 0 -2.238584 -5.409106 -5.314718 +231 77 2 0 -0.948185 -4.908428 -5.559580 +232 78 1 0 -3.623435 -8.061229 1.383141 +233 78 2 0 -3.132847 -7.446722 1.857906 +234 78 2 0 -4.307943 -7.546630 0.933298 +235 79 1 0 5.717894 6.958376 4.528556 +236 79 2 0 5.852657 7.879846 4.341790 +237 79 2 0 6.443636 6.708413 5.135144 +238 80 1 0 8.121415 8.262619 -8.483986 +239 80 2 0 8.585190 8.939651 -8.974230 +240 80 2 0 7.560207 7.748539 -9.044644 +241 81 1 0 -5.111889 -0.352865 5.807903 +242 81 2 0 -5.940048 0.102298 5.569630 +243 81 2 0 -5.349104 -1.014090 6.507582 +244 82 1 0 0.327324 2.563438 0.113251 +245 82 2 0 -0.633994 2.522136 -0.069385 +246 82 2 0 0.724331 3.482989 0.160564 +247 83 1 0 -6.003367 -7.683112 -8.874252 +248 83 2 0 -6.987751 -7.912403 -8.892689 +249 83 2 0 -5.699015 -8.504722 -8.558813 +250 84 1 0 0.789377 -6.357883 -7.563043 +251 84 2 0 -0.151101 -6.341313 -7.440906 +252 84 2 0 1.090881 -5.879281 -6.770796 +253 85 1 0 5.045666 7.219298 -5.151826 +254 85 2 0 5.598994 7.846492 -5.618276 +255 85 2 0 5.480466 6.978976 -4.337211 +256 86 1 0 1.286092 6.990271 -6.806004 +257 86 2 0 0.481329 7.140371 -7.345224 +258 86 2 0 1.716012 7.791024 -6.762706 +259 87 1 0 -3.198783 -9.175883 -6.334156 +260 87 2 0 -3.032721 -8.198157 -6.198635 +261 87 2 0 -3.084774 -9.539992 -5.434969 +262 88 1 0 -2.002554 -5.668583 5.440781 +263 88 2 0 -2.347493 -4.756386 5.542471 +264 88 2 0 -2.133027 -6.049986 4.540349 +265 89 1 0 6.174952 -8.574733 0.210584 +266 89 2 0 5.358389 -8.191902 0.557392 +267 89 2 0 6.760918 -8.561710 0.943985 +268 90 1 0 -6.278610 6.057339 4.042358 +269 90 2 0 -6.169211 6.708022 3.383078 +270 90 2 0 -7.221766 5.771239 4.032205 +271 91 1 0 0.124733 -5.816398 0.203961 +272 91 2 0 0.029974 -5.049468 0.786871 +273 91 2 0 -0.458026 -5.646677 -0.555312 +274 92 1 0 3.839311 -0.064469 8.619720 +275 92 2 0 3.586253 -0.282978 7.705313 +276 92 2 0 3.079936 0.282626 9.065559 +277 93 1 0 7.375986 -1.368885 4.452411 +278 93 2 0 8.024931 -0.682735 4.768078 +279 93 2 0 7.477247 -1.279372 3.493009 +280 94 1 0 9.209092 -1.611532 -6.423337 +281 94 2 0 9.487648 -2.470973 -6.800897 +282 94 2 0 9.998917 -1.354277 -5.866779 +283 95 1 0 -5.314625 -5.613762 7.941745 +284 95 2 0 -5.589748 -6.389969 8.478078 +285 95 2 0 -4.444519 -5.357513 8.149460 +286 96 1 0 -3.655884 2.941259 -3.295211 +287 96 2 0 -4.418712 2.528163 -3.712668 +288 96 2 0 -2.937568 3.025005 -3.971189 +289 97 1 0 -8.786626 -3.149090 -1.640379 +290 97 2 0 -8.441651 -4.011755 -1.901885 +291 97 2 0 -9.285717 -3.276173 -0.834535 +292 98 1 0 -7.358188 8.239942 -2.093781 +293 98 2 0 -7.811518 7.751233 -2.768278 +294 98 2 0 -6.892430 7.625331 -1.541437 +295 99 1 0 3.770974 -0.453172 -1.931225 +296 99 2 0 4.245757 -0.966218 -1.286114 +297 99 2 0 3.797803 0.441972 -1.542180 +298 100 1 0 2.205813 4.098894 8.958738 +299 100 2 0 3.001973 3.555440 8.746430 +300 100 2 0 2.103639 4.243668 9.940011 +301 101 1 0 -8.723398 -8.284874 -8.890692 +302 101 2 0 -9.298972 -7.537539 -9.239127 +303 101 2 0 -8.772683 -8.361037 -7.925940 +304 102 1 0 -8.908952 0.807167 -7.785764 +305 102 2 0 -9.061230 -0.061912 -7.422589 +306 102 2 0 -9.534219 1.030144 -8.475490 +307 103 1 0 9.182207 -3.418263 -8.430667 +308 103 2 0 9.046738 -2.558299 -8.879898 +309 103 2 0 8.390804 -3.958734 -8.701949 +310 104 1 0 1.003162 9.279867 -8.313986 +311 104 2 0 1.167271 10.190392 -8.070619 +312 104 2 0 1.849962 8.761188 -8.493178 +313 105 1 0 -1.842572 4.893383 8.198130 +314 105 2 0 -2.468210 5.316242 8.833179 +315 105 2 0 -1.155294 4.389410 8.716281 +316 106 1 0 -4.005055 -3.953707 0.402347 +317 106 2 0 -3.682148 -3.305443 1.058769 +318 106 2 0 -4.738199 -4.452434 0.841144 +319 107 1 0 3.511815 -7.590537 -9.004707 +320 107 2 0 3.415066 -7.281286 -8.094635 +321 107 2 0 3.251550 -6.835442 -9.579171 +322 108 1 0 -7.614136 -7.773463 1.262079 +323 108 2 0 -7.489497 -6.927033 0.753779 +324 108 2 0 -8.528840 -8.050689 1.164710 +325 109 1 0 -5.419143 7.061880 -5.745275 +326 109 2 0 -4.504905 6.840455 -5.750772 +327 109 2 0 -5.895918 6.221393 -5.676189 +328 110 1 0 -9.017162 1.888781 0.937813 +329 110 2 0 -9.868157 2.115056 0.623903 +330 110 2 0 -8.466599 1.708818 0.191067 +331 111 1 0 -8.037596 -5.106016 4.750802 +332 111 2 0 -7.322228 -5.707104 5.043673 +333 111 2 0 -8.230169 -4.481051 5.475067 +334 112 1 0 -4.390546 1.691502 -7.756245 +335 112 2 0 -3.558844 1.264966 -7.996466 +336 112 2 0 -4.136121 2.629917 -7.760619 +337 113 1 0 -3.975194 -6.218233 -6.927330 +338 113 2 0 -3.085645 -6.066352 -7.325296 +339 113 2 0 -4.640815 -6.676349 -7.524295 +340 114 1 0 8.240648 5.082183 -8.857912 +341 114 2 0 7.453645 5.101728 -8.259448 +342 114 2 0 8.368223 4.228825 -9.227974 +343 115 1 0 1.598931 -1.829796 -0.316752 +344 115 2 0 1.992252 -1.475465 -1.149815 +345 115 2 0 1.726926 -2.749881 -0.397199 +346 116 1 0 1.433819 -1.386702 -3.304673 +347 116 2 0 1.323094 -0.486757 -3.067110 +348 116 2 0 0.623143 -1.802016 -3.264828 +349 117 1 0 3.735991 5.554990 6.219603 +350 117 2 0 3.320916 6.265941 6.761937 +351 117 2 0 4.195666 6.053207 5.526652 +352 118 1 0 -6.285976 -9.228132 -4.460410 +353 118 2 0 -5.683885 -10.005163 -4.740870 +354 118 2 0 -6.707036 -9.488426 -3.608438 +355 119 1 0 4.036200 -3.378299 6.905724 +356 119 2 0 3.457441 -2.618106 6.794504 +357 119 2 0 4.929409 -2.991177 6.666963 +358 120 1 0 0.606517 8.561279 -3.782406 +359 120 2 0 0.498099 9.526035 -3.699299 +360 120 2 0 1.288545 8.500162 -4.475972 +361 121 1 0 -5.666717 8.368298 -8.299623 +362 121 2 0 -4.926661 7.904359 -8.744783 +363 121 2 0 -5.742748 8.095703 -7.389592 +364 122 1 0 -3.344692 7.636718 3.475830 +365 122 2 0 -4.140634 7.105012 3.296472 +366 122 2 0 -3.350797 7.470949 4.433350 +367 123 1 0 -1.322186 6.638182 0.028906 +368 123 2 0 -1.895088 6.054034 0.554933 +369 123 2 0 -1.928852 7.271511 -0.442137 +370 124 1 0 8.793551 6.925450 7.841717 +371 124 2 0 9.639675 7.325848 7.850680 +372 124 2 0 8.776882 6.398711 8.674036 +373 125 1 0 -6.322101 0.607808 1.174099 +374 125 2 0 -5.647986 1.150825 1.588348 +375 125 2 0 -5.852992 -0.060471 0.660730 +376 126 1 0 5.685139 -3.546046 -4.128549 +377 126 2 0 4.727966 -3.473549 -4.165755 +378 126 2 0 6.024761 -2.749532 -4.610993 +379 127 1 0 3.821999 6.538527 1.678030 +380 127 2 0 3.549684 7.331168 1.175762 +381 127 2 0 3.816423 6.788603 2.602522 +382 128 1 0 3.892622 -7.034239 -6.415978 +383 128 2 0 4.720509 -6.539827 -6.295004 +384 128 2 0 3.262810 -6.550918 -5.890370 +385 129 1 0 5.454437 3.881722 -2.767521 +386 129 2 0 5.906266 3.240489 -3.272250 +387 129 2 0 6.116652 4.657253 -2.669082 +388 130 1 0 -4.179373 -8.326009 4.395005 +389 130 2 0 -3.737878 -8.754475 5.134173 +390 130 2 0 -3.934584 -8.825320 3.534465 +391 131 1 0 7.949488 -1.353498 9.244688 +392 131 2 0 7.234465 -1.100736 9.869694 +393 131 2 0 8.010855 -0.754076 8.476271 +394 132 1 0 4.498603 -4.219267 3.963173 +395 132 2 0 4.895226 -3.311215 4.147093 +396 132 2 0 4.802371 -4.871698 4.671292 +397 133 1 0 -4.307250 7.384668 -2.879462 +398 133 2 0 -3.402854 7.237543 -3.252031 +399 133 2 0 -4.143231 7.834459 -2.019767 +400 134 1 0 2.868752 -0.418389 1.909340 +401 134 2 0 2.544472 -0.880398 1.179279 +402 134 2 0 2.082841 -0.227627 2.457964 +403 135 1 0 7.961389 1.611971 4.525253 +404 135 2 0 7.498497 1.833174 3.728113 +405 135 2 0 8.841880 2.050996 4.576281 +406 136 1 0 2.692467 -4.517946 -0.884665 +407 136 2 0 1.789435 -4.835617 -0.587396 +408 136 2 0 3.330887 -5.126025 -0.474679 +409 137 1 0 0.711797 1.680547 -4.780435 +410 137 2 0 0.854596 1.567911 -3.850059 +411 137 2 0 -0.187286 1.868256 -4.936632 +412 138 1 0 4.558200 -0.044434 -4.673875 +413 138 2 0 5.376141 -0.551202 -4.913295 +414 138 2 0 4.409600 -0.197728 -3.739555 +415 139 1 0 7.109730 0.453475 -0.268844 +416 139 2 0 6.996444 0.098599 -1.119484 +417 139 2 0 6.343115 1.050849 -0.110689 +418 140 1 0 -2.549577 -0.200852 -4.492507 +419 140 2 0 -3.199039 -0.856439 -4.888752 +420 140 2 0 -2.605120 -0.151501 -3.534000 +421 141 1 0 -8.527353 4.524174 -2.347408 +422 141 2 0 -7.662213 4.342466 -2.104852 +423 141 2 0 -8.794374 3.696793 -2.795740 +424 142 1 0 -2.820431 -0.700478 4.413266 +425 142 2 0 -2.088343 -0.069797 4.530521 +426 142 2 0 -3.535913 -0.413547 5.069151 +427 143 1 0 6.924598 -1.285634 -4.901833 +428 143 2 0 7.496477 -0.831510 -4.206076 +429 143 2 0 7.527035 -1.446676 -5.677236 +430 144 1 0 -5.353763 6.572088 6.734366 +431 144 2 0 -4.428432 6.663173 6.834862 +432 144 2 0 -5.603600 6.385787 5.822425 +433 145 1 0 7.661597 2.386104 9.175259 +434 145 2 0 7.321694 2.395921 10.055536 +435 145 2 0 6.959141 2.102200 8.533079 +436 146 1 0 -3.496590 -3.765912 -4.994838 +437 146 2 0 -3.612181 -3.620689 -4.036115 +438 146 2 0 -4.323649 -3.527816 -5.463213 +439 147 1 0 -9.351953 8.343146 3.704719 +440 147 2 0 -8.465363 8.758592 3.736785 +441 147 2 0 -9.159223 7.399420 3.880808 +442 148 1 0 -0.957571 -5.174275 -2.190170 +443 148 2 0 -1.907345 -5.209294 -2.303164 +444 148 2 0 -0.758582 -4.314608 -2.636469 +445 149 1 0 5.048831 -7.988284 2.587515 +446 149 2 0 5.870168 -8.296198 3.043816 +447 149 2 0 4.551970 -7.498875 3.229280 +448 150 1 0 3.705658 8.368298 -8.304931 +449 150 2 0 3.860607 9.297256 -8.425405 +450 150 2 0 3.866516 8.146007 -7.371475 +451 151 1 0 -2.535134 7.116414 6.338590 +452 151 2 0 -1.918884 7.705593 6.804078 +453 151 2 0 -1.975225 6.330832 6.121365 +454 152 1 0 -3.440263 7.005018 9.111704 +455 152 2 0 -2.633953 7.421761 9.465848 +456 152 2 0 -3.654896 7.513753 8.256470 +457 153 1 0 6.452501 -5.478051 -5.722874 +458 153 2 0 7.297698 -5.914122 -5.586895 +459 153 2 0 6.253267 -4.919338 -4.937095 +460 154 1 0 -6.528475 4.497861 -5.573636 +461 154 2 0 -6.257840 4.684056 -4.656222 +462 154 2 0 -7.247764 3.931701 -5.623068 +463 155 1 0 -7.310706 8.183648 7.852201 +464 155 2 0 -6.552879 7.735013 7.436342 +465 155 2 0 -6.877865 8.451022 8.686616 +466 156 1 0 -1.476441 -7.867001 7.421787 +467 156 2 0 -0.852398 -8.570669 7.084405 +468 156 2 0 -1.363740 -7.190554 6.737331 +469 157 1 0 5.228019 -0.495870 -7.592953 +470 157 2 0 4.737616 -0.538139 -6.742036 +471 157 2 0 4.625354 -0.901329 -8.269022 +472 158 1 0 7.566531 -1.006734 1.808213 +473 158 2 0 7.657411 -1.866188 1.428564 +474 158 2 0 7.358547 -0.388051 1.139943 +475 159 1 0 1.850924 -5.717449 -5.035416 +476 159 2 0 1.721040 -6.227449 -4.217213 +477 159 2 0 2.199319 -4.856378 -4.692892 +478 160 1 0 -8.904325 6.791585 -3.842866 +479 160 2 0 -8.690637 5.952112 -3.490118 +480 160 2 0 -8.676001 6.844077 -4.770651 +481 161 1 0 -3.434304 4.397198 -7.863568 +482 161 2 0 -2.634777 3.892027 -7.779256 +483 161 2 0 -3.432847 5.161485 -7.310788 +484 162 1 0 -7.446738 6.124823 0.150068 +485 162 2 0 -7.404893 5.207959 0.481504 +486 162 2 0 -8.405563 6.215466 -0.024439 +487 163 1 0 0.195330 -7.307128 -3.501714 +488 163 2 0 -0.240912 -6.769004 -4.243655 +489 163 2 0 -0.194915 -6.981989 -2.679860 +490 164 1 0 7.068819 9.130323 7.260588 +491 164 2 0 6.559855 8.400987 7.699406 +492 164 2 0 7.972497 8.829223 7.213747 +493 165 1 0 -0.185218 -3.192290 -6.289346 +494 165 2 0 0.776651 -3.073203 -6.391948 +495 165 2 0 -0.497426 -2.964088 -7.170893 +496 166 1 0 -2.073630 4.369672 5.251074 +497 166 2 0 -1.868638 3.811508 6.060261 +498 166 2 0 -1.253174 4.326708 4.781680 +499 167 1 0 -0.855003 3.069108 -7.935226 +500 167 2 0 0.075758 3.132202 -7.617253 +501 167 2 0 -1.009845 2.207487 -8.320426 +502 168 1 0 -6.328833 0.064083 -8.467228 +503 168 2 0 -7.268416 0.384648 -8.383978 +504 168 2 0 -5.825246 0.919304 -8.320175 +505 169 1 0 -8.276352 -8.809851 -6.344910 +506 169 2 0 -7.541457 -8.792368 -5.688031 +507 169 2 0 -8.510208 -9.731116 -6.353248 +508 170 1 0 0.463654 2.826776 7.018388 +509 170 2 0 0.875324 3.588447 7.482107 +510 170 2 0 0.770257 2.126646 7.583650 +511 171 1 0 0.478371 -3.407198 6.910039 +512 171 2 0 0.585298 -2.996750 7.756467 +513 171 2 0 0.556531 -4.390636 7.183527 +514 172 1 0 -1.689559 7.002511 -3.303561 +515 172 2 0 -1.009152 7.635432 -3.553133 +516 172 2 0 -1.333699 6.195680 -2.919485 +517 173 1 0 9.000097 -6.227871 8.137681 +518 173 2 0 9.373858 -6.821152 7.497417 +519 173 2 0 8.024020 -6.011019 8.033727 +520 174 1 0 1.272378 1.954065 3.058033 +521 174 2 0 1.260842 2.615112 2.341207 +522 174 2 0 1.890312 2.223439 3.732934 +523 175 1 0 4.139066 -3.527427 -9.022609 +524 175 2 0 4.070028 -3.499117 -9.985525 +525 175 2 0 4.960292 -3.942364 -8.778433 +526 176 1 0 7.176276 2.178662 -4.075940 +527 176 2 0 6.995275 1.684022 -4.873223 +528 176 2 0 7.621313 2.984315 -4.393994 +529 177 1 0 -0.034836 -3.929919 2.148095 +530 177 2 0 0.838003 -3.513346 2.259663 +531 177 2 0 -0.654999 -3.288581 2.426748 +532 178 1 0 -8.701616 2.795237 -5.700842 +533 178 2 0 -8.848959 2.145603 -6.420186 +534 178 2 0 -9.464654 3.362988 -5.610379 +535 179 1 0 2.804444 8.909551 -5.635389 +536 179 2 0 3.063615 9.805993 -5.770957 +537 179 2 0 3.512196 8.486179 -5.165468 +538 180 1 0 3.236002 8.357402 3.636639 +539 180 2 0 3.450854 9.071799 3.073263 +540 180 2 0 3.476445 8.586691 4.607935 +541 181 1 0 5.628532 7.185941 8.510937 +542 181 2 0 5.467837 6.318153 8.138885 +543 181 2 0 4.964153 7.477925 9.150467 +544 182 1 0 -3.767261 1.260390 2.017681 +545 182 2 0 -3.707734 2.019520 2.565591 +546 182 2 0 -3.364602 1.609935 1.212351 +547 183 1 0 8.228917 -3.441761 0.850139 +548 183 2 0 9.022130 -3.709208 1.334881 +549 183 2 0 7.553662 -3.976731 1.276651 +550 184 1 0 -3.004292 1.345869 7.236734 +551 184 2 0 -3.715311 0.724731 6.912689 +552 184 2 0 -3.525684 2.111901 7.538936 +553 185 1 0 4.901423 -5.547141 -0.119795 +554 185 2 0 5.327550 -5.560969 0.769770 +555 185 2 0 5.447642 -4.930752 -0.617088 +556 186 1 0 -3.306210 8.469477 -0.495057 +557 186 2 0 -2.836855 9.122642 -1.080706 +558 186 2 0 -3.311215 8.916887 0.353875 +559 187 1 0 -6.572180 3.018421 -0.262079 +560 187 2 0 -6.711444 2.659956 0.606460 +561 187 2 0 -6.040782 2.473886 -0.843542 +562 188 1 0 -5.429147 -5.967833 5.177682 +563 188 2 0 -4.896648 -6.608203 4.692534 +564 188 2 0 -5.386594 -6.130690 6.117931 +565 189 1 0 6.054430 7.035601 0.031519 +566 189 2 0 5.939348 7.951184 -0.141094 +567 189 2 0 5.390949 6.866654 0.702638 +568 190 1 0 -0.890229 -2.615376 -3.621726 +569 190 2 0 -1.695442 -2.097314 -3.537976 +570 190 2 0 -0.895128 -2.637531 -4.561712 +571 191 1 0 -5.446979 0.994907 -2.106714 +572 191 2 0 -4.494883 0.997912 -1.881595 +573 191 2 0 -5.759736 0.094199 -1.919247 +574 192 1 0 -7.517688 -4.078340 7.202707 +575 192 2 0 -8.242348 -4.324693 7.729813 +576 192 2 0 -6.924399 -4.817453 7.269430 +577 193 1 0 -1.134884 8.628488 2.081069 +578 193 2 0 -1.962897 8.634713 2.554947 +579 193 2 0 -1.119731 7.882422 1.516003 +580 194 1 0 -6.288317 8.011683 2.022129 +581 194 2 0 -6.404647 8.858198 1.546109 +582 194 2 0 -6.669138 7.315199 1.482614 +583 195 1 0 -6.766934 -4.026505 -8.306645 +584 195 2 0 -6.542552 -4.855702 -8.828363 +585 195 2 0 -7.743726 -3.954163 -8.170031 +586 196 1 0 6.895244 7.052113 -3.031289 +587 196 2 0 7.810039 7.265357 -3.330751 +588 196 2 0 6.666757 7.541675 -2.202178 +589 197 1 0 8.003260 4.735929 -5.168656 +590 197 2 0 7.233375 4.730204 -5.685772 +591 197 2 0 8.406708 5.629580 -5.300038 +592 198 1 0 -5.230160 -6.461196 -4.390836 +593 198 2 0 -5.701559 -7.313756 -4.377348 +594 198 2 0 -4.855545 -6.327970 -5.273444 +595 199 1 0 -3.803496 -9.221115 7.305476 +596 199 2 0 -2.934288 -8.877999 7.425047 +597 199 2 0 -4.416066 -8.566250 7.573191 +598 200 1 0 -5.990438 -1.574415 3.072521 +599 200 2 0 -5.805447 -1.119293 3.933731 +600 200 2 0 -6.651651 -0.947206 2.634773 +601 201 1 0 1.155451 7.138377 -1.178317 +602 201 2 0 0.330359 7.363227 -0.724568 +603 201 2 0 1.055145 7.478676 -2.100793 +604 202 1 0 -5.886817 5.150957 -2.997276 +605 202 2 0 -5.191777 4.556623 -2.611465 +606 202 2 0 -5.401622 6.003350 -3.064194 +607 203 1 0 2.539927 3.387568 4.976180 +608 203 2 0 1.760904 3.182324 5.589217 +609 203 2 0 2.841539 4.315465 5.278853 +610 204 1 0 8.331859 -7.344673 -5.188191 +611 204 2 0 8.424401 -7.586778 -4.198621 +612 204 2 0 8.911675 -7.764424 -5.823267 +613 205 1 0 -5.774081 1.315144 -5.304553 +614 205 2 0 -5.222992 1.580336 -6.077077 +615 205 2 0 -6.219878 2.178441 -5.093360 +616 206 1 0 6.340084 -4.926064 2.149626 +617 206 2 0 5.639784 -4.766017 2.829591 +618 206 2 0 6.883511 -5.598794 2.562820 +619 207 1 0 -2.722394 6.614441 -5.843805 +620 207 2 0 -2.332414 7.251953 -6.403722 +621 207 2 0 -2.221682 6.596615 -5.034993 +622 208 1 0 -1.813152 0.712824 -9.048176 +623 208 2 0 -1.763921 -0.271744 -8.916841 +624 208 2 0 -2.097796 0.860500 -9.970314 +625 209 1 0 6.146244 -6.879929 8.376712 +626 209 2 0 5.324465 -7.183905 8.841506 +627 209 2 0 6.642264 -7.749945 8.201756 +628 210 1 0 2.887544 8.612615 0.453821 +629 210 2 0 2.452117 8.047637 -0.251289 +630 210 2 0 2.348751 9.285636 0.895642 +631 211 1 0 -8.475558 -8.180718 6.501232 +632 211 2 0 -8.034310 -8.945692 6.891221 +633 211 2 0 -8.173606 -8.179435 5.569319 +634 212 1 0 6.714205 -2.947903 6.551671 +635 212 2 0 7.143284 -2.459194 7.270891 +636 212 2 0 7.212365 -2.637046 5.791018 +637 213 1 0 6.445003 -5.462306 5.577966 +638 213 2 0 6.730099 -4.696457 6.073312 +639 213 2 0 6.099428 -6.099736 6.222859 +640 214 1 0 -1.818761 -6.080111 -8.805420 +641 214 2 0 -1.644534 -6.777931 -9.477669 +642 214 2 0 -2.078582 -5.258591 -9.215838 +643 215 1 0 6.037377 2.950576 2.863541 +644 215 2 0 6.409766 3.757001 2.570754 +645 215 2 0 5.577033 2.617474 2.090587 +646 216 1 0 -7.731645 3.337668 3.301121 +647 216 2 0 -8.345957 4.027222 3.589257 +648 216 2 0 -8.130328 2.845238 2.577949 + +Bonds + +1 1 1 2 +2 1 1 3 +3 1 4 5 +4 1 4 6 +5 1 7 8 +6 1 7 9 +7 1 10 11 +8 1 10 12 +9 1 13 14 +10 1 13 15 +11 1 16 17 +12 1 16 18 +13 1 19 20 +14 1 19 21 +15 1 22 23 +16 1 22 24 +17 1 25 26 +18 1 25 27 +19 1 28 29 +20 1 28 30 +21 1 31 32 +22 1 31 33 +23 1 34 35 +24 1 34 36 +25 1 37 38 +26 1 37 39 +27 1 40 41 +28 1 40 42 +29 1 43 44 +30 1 43 45 +31 1 46 47 +32 1 46 48 +33 1 49 50 +34 1 49 51 +35 1 52 53 +36 1 52 54 +37 1 55 56 +38 1 55 57 +39 1 58 59 +40 1 58 60 +41 1 61 62 +42 1 61 63 +43 1 64 65 +44 1 64 66 +45 1 67 68 +46 1 67 69 +47 1 70 71 +48 1 70 72 +49 1 73 74 +50 1 73 75 +51 1 76 77 +52 1 76 78 +53 1 79 80 +54 1 79 81 +55 1 82 83 +56 1 82 84 +57 1 85 86 +58 1 85 87 +59 1 88 89 +60 1 88 90 +61 1 91 92 +62 1 91 93 +63 1 94 95 +64 1 94 96 +65 1 97 98 +66 1 97 99 +67 1 100 101 +68 1 100 102 +69 1 103 104 +70 1 103 105 +71 1 106 107 +72 1 106 108 +73 1 109 110 +74 1 109 111 +75 1 112 113 +76 1 112 114 +77 1 115 116 +78 1 115 117 +79 1 118 119 +80 1 118 120 +81 1 121 122 +82 1 121 123 +83 1 124 125 +84 1 124 126 +85 1 127 128 +86 1 127 129 +87 1 130 131 +88 1 130 132 +89 1 133 134 +90 1 133 135 +91 1 136 137 +92 1 136 138 +93 1 139 140 +94 1 139 141 +95 1 142 143 +96 1 142 144 +97 1 145 146 +98 1 145 147 +99 1 148 149 +100 1 148 150 +101 1 151 152 +102 1 151 153 +103 1 154 155 +104 1 154 156 +105 1 157 158 +106 1 157 159 +107 1 160 161 +108 1 160 162 +109 1 163 164 +110 1 163 165 +111 1 166 167 +112 1 166 168 +113 1 169 170 +114 1 169 171 +115 1 172 173 +116 1 172 174 +117 1 175 176 +118 1 175 177 +119 1 178 179 +120 1 178 180 +121 1 181 182 +122 1 181 183 +123 1 184 185 +124 1 184 186 +125 1 187 188 +126 1 187 189 +127 1 190 191 +128 1 190 192 +129 1 193 194 +130 1 193 195 +131 1 196 197 +132 1 196 198 +133 1 199 200 +134 1 199 201 +135 1 202 203 +136 1 202 204 +137 1 205 206 +138 1 205 207 +139 1 208 209 +140 1 208 210 +141 1 211 212 +142 1 211 213 +143 1 214 215 +144 1 214 216 +145 1 217 218 +146 1 217 219 +147 1 220 221 +148 1 220 222 +149 1 223 224 +150 1 223 225 +151 1 226 227 +152 1 226 228 +153 1 229 230 +154 1 229 231 +155 1 232 233 +156 1 232 234 +157 1 235 236 +158 1 235 237 +159 1 238 239 +160 1 238 240 +161 1 241 242 +162 1 241 243 +163 1 244 245 +164 1 244 246 +165 1 247 248 +166 1 247 249 +167 1 250 251 +168 1 250 252 +169 1 253 254 +170 1 253 255 +171 1 256 257 +172 1 256 258 +173 1 259 260 +174 1 259 261 +175 1 262 263 +176 1 262 264 +177 1 265 266 +178 1 265 267 +179 1 268 269 +180 1 268 270 +181 1 271 272 +182 1 271 273 +183 1 274 275 +184 1 274 276 +185 1 277 278 +186 1 277 279 +187 1 280 281 +188 1 280 282 +189 1 283 284 +190 1 283 285 +191 1 286 287 +192 1 286 288 +193 1 289 290 +194 1 289 291 +195 1 292 293 +196 1 292 294 +197 1 295 296 +198 1 295 297 +199 1 298 299 +200 1 298 300 +201 1 301 302 +202 1 301 303 +203 1 304 305 +204 1 304 306 +205 1 307 308 +206 1 307 309 +207 1 310 311 +208 1 310 312 +209 1 313 314 +210 1 313 315 +211 1 316 317 +212 1 316 318 +213 1 319 320 +214 1 319 321 +215 1 322 323 +216 1 322 324 +217 1 325 326 +218 1 325 327 +219 1 328 329 +220 1 328 330 +221 1 331 332 +222 1 331 333 +223 1 334 335 +224 1 334 336 +225 1 337 338 +226 1 337 339 +227 1 340 341 +228 1 340 342 +229 1 343 344 +230 1 343 345 +231 1 346 347 +232 1 346 348 +233 1 349 350 +234 1 349 351 +235 1 352 353 +236 1 352 354 +237 1 355 356 +238 1 355 357 +239 1 358 359 +240 1 358 360 +241 1 361 362 +242 1 361 363 +243 1 364 365 +244 1 364 366 +245 1 367 368 +246 1 367 369 +247 1 370 371 +248 1 370 372 +249 1 373 374 +250 1 373 375 +251 1 376 377 +252 1 376 378 +253 1 379 380 +254 1 379 381 +255 1 382 383 +256 1 382 384 +257 1 385 386 +258 1 385 387 +259 1 388 389 +260 1 388 390 +261 1 391 392 +262 1 391 393 +263 1 394 395 +264 1 394 396 +265 1 397 398 +266 1 397 399 +267 1 400 401 +268 1 400 402 +269 1 403 404 +270 1 403 405 +271 1 406 407 +272 1 406 408 +273 1 409 410 +274 1 409 411 +275 1 412 413 +276 1 412 414 +277 1 415 416 +278 1 415 417 +279 1 418 419 +280 1 418 420 +281 1 421 422 +282 1 421 423 +283 1 424 425 +284 1 424 426 +285 1 427 428 +286 1 427 429 +287 1 430 431 +288 1 430 432 +289 1 433 434 +290 1 433 435 +291 1 436 437 +292 1 436 438 +293 1 439 440 +294 1 439 441 +295 1 442 443 +296 1 442 444 +297 1 445 446 +298 1 445 447 +299 1 448 449 +300 1 448 450 +301 1 451 452 +302 1 451 453 +303 1 454 455 +304 1 454 456 +305 1 457 458 +306 1 457 459 +307 1 460 461 +308 1 460 462 +309 1 463 464 +310 1 463 465 +311 1 466 467 +312 1 466 468 +313 1 469 470 +314 1 469 471 +315 1 472 473 +316 1 472 474 +317 1 475 476 +318 1 475 477 +319 1 478 479 +320 1 478 480 +321 1 481 482 +322 1 481 483 +323 1 484 485 +324 1 484 486 +325 1 487 488 +326 1 487 489 +327 1 490 491 +328 1 490 492 +329 1 493 494 +330 1 493 495 +331 1 496 497 +332 1 496 498 +333 1 499 500 +334 1 499 501 +335 1 502 503 +336 1 502 504 +337 1 505 506 +338 1 505 507 +339 1 508 509 +340 1 508 510 +341 1 511 512 +342 1 511 513 +343 1 514 515 +344 1 514 516 +345 1 517 518 +346 1 517 519 +347 1 520 521 +348 1 520 522 +349 1 523 524 +350 1 523 525 +351 1 526 527 +352 1 526 528 +353 1 529 530 +354 1 529 531 +355 1 532 533 +356 1 532 534 +357 1 535 536 +358 1 535 537 +359 1 538 539 +360 1 538 540 +361 1 541 542 +362 1 541 543 +363 1 544 545 +364 1 544 546 +365 1 547 548 +366 1 547 549 +367 1 550 551 +368 1 550 552 +369 1 553 554 +370 1 553 555 +371 1 556 557 +372 1 556 558 +373 1 559 560 +374 1 559 561 +375 1 562 563 +376 1 562 564 +377 1 565 566 +378 1 565 567 +379 1 568 569 +380 1 568 570 +381 1 571 572 +382 1 571 573 +383 1 574 575 +384 1 574 576 +385 1 577 578 +386 1 577 579 +387 1 580 581 +388 1 580 582 +389 1 583 584 +390 1 583 585 +391 1 586 587 +392 1 586 588 +393 1 589 590 +394 1 589 591 +395 1 592 593 +396 1 592 594 +397 1 595 596 +398 1 595 597 +399 1 598 599 +400 1 598 600 +401 1 601 602 +402 1 601 603 +403 1 604 605 +404 1 604 606 +405 1 607 608 +406 1 607 609 +407 1 610 611 +408 1 610 612 +409 1 613 614 +410 1 613 615 +411 1 616 617 +412 1 616 618 +413 1 619 620 +414 1 619 621 +415 1 622 623 +416 1 622 624 +417 1 625 626 +418 1 625 627 +419 1 628 629 +420 1 628 630 +421 1 631 632 +422 1 631 633 +423 1 634 635 +424 1 634 636 +425 1 637 638 +426 1 637 639 +427 1 640 641 +428 1 640 642 +429 1 643 644 +430 1 643 645 +431 1 646 647 +432 1 646 648 + +Angles + +1 1 2 1 3 +2 1 5 4 6 +3 1 8 7 9 +4 1 11 10 12 +5 1 14 13 15 +6 1 17 16 18 +7 1 20 19 21 +8 1 23 22 24 +9 1 26 25 27 +10 1 29 28 30 +11 1 32 31 33 +12 1 35 34 36 +13 1 38 37 39 +14 1 41 40 42 +15 1 44 43 45 +16 1 47 46 48 +17 1 50 49 51 +18 1 53 52 54 +19 1 56 55 57 +20 1 59 58 60 +21 1 62 61 63 +22 1 65 64 66 +23 1 68 67 69 +24 1 71 70 72 +25 1 74 73 75 +26 1 77 76 78 +27 1 80 79 81 +28 1 83 82 84 +29 1 86 85 87 +30 1 89 88 90 +31 1 92 91 93 +32 1 95 94 96 +33 1 98 97 99 +34 1 101 100 102 +35 1 104 103 105 +36 1 107 106 108 +37 1 110 109 111 +38 1 113 112 114 +39 1 116 115 117 +40 1 119 118 120 +41 1 122 121 123 +42 1 125 124 126 +43 1 128 127 129 +44 1 131 130 132 +45 1 134 133 135 +46 1 137 136 138 +47 1 140 139 141 +48 1 143 142 144 +49 1 146 145 147 +50 1 149 148 150 +51 1 152 151 153 +52 1 155 154 156 +53 1 158 157 159 +54 1 161 160 162 +55 1 164 163 165 +56 1 167 166 168 +57 1 170 169 171 +58 1 173 172 174 +59 1 176 175 177 +60 1 179 178 180 +61 1 182 181 183 +62 1 185 184 186 +63 1 188 187 189 +64 1 191 190 192 +65 1 194 193 195 +66 1 197 196 198 +67 1 200 199 201 +68 1 203 202 204 +69 1 206 205 207 +70 1 209 208 210 +71 1 212 211 213 +72 1 215 214 216 +73 1 218 217 219 +74 1 221 220 222 +75 1 224 223 225 +76 1 227 226 228 +77 1 230 229 231 +78 1 233 232 234 +79 1 236 235 237 +80 1 239 238 240 +81 1 242 241 243 +82 1 245 244 246 +83 1 248 247 249 +84 1 251 250 252 +85 1 254 253 255 +86 1 257 256 258 +87 1 260 259 261 +88 1 263 262 264 +89 1 266 265 267 +90 1 269 268 270 +91 1 272 271 273 +92 1 275 274 276 +93 1 278 277 279 +94 1 281 280 282 +95 1 284 283 285 +96 1 287 286 288 +97 1 290 289 291 +98 1 293 292 294 +99 1 296 295 297 +100 1 299 298 300 +101 1 302 301 303 +102 1 305 304 306 +103 1 308 307 309 +104 1 311 310 312 +105 1 314 313 315 +106 1 317 316 318 +107 1 320 319 321 +108 1 323 322 324 +109 1 326 325 327 +110 1 329 328 330 +111 1 332 331 333 +112 1 335 334 336 +113 1 338 337 339 +114 1 341 340 342 +115 1 344 343 345 +116 1 347 346 348 +117 1 350 349 351 +118 1 353 352 354 +119 1 356 355 357 +120 1 359 358 360 +121 1 362 361 363 +122 1 365 364 366 +123 1 368 367 369 +124 1 371 370 372 +125 1 374 373 375 +126 1 377 376 378 +127 1 380 379 381 +128 1 383 382 384 +129 1 386 385 387 +130 1 389 388 390 +131 1 392 391 393 +132 1 395 394 396 +133 1 398 397 399 +134 1 401 400 402 +135 1 404 403 405 +136 1 407 406 408 +137 1 410 409 411 +138 1 413 412 414 +139 1 416 415 417 +140 1 419 418 420 +141 1 422 421 423 +142 1 425 424 426 +143 1 428 427 429 +144 1 431 430 432 +145 1 434 433 435 +146 1 437 436 438 +147 1 440 439 441 +148 1 443 442 444 +149 1 446 445 447 +150 1 449 448 450 +151 1 452 451 453 +152 1 455 454 456 +153 1 458 457 459 +154 1 461 460 462 +155 1 464 463 465 +156 1 467 466 468 +157 1 470 469 471 +158 1 473 472 474 +159 1 476 475 477 +160 1 479 478 480 +161 1 482 481 483 +162 1 485 484 486 +163 1 488 487 489 +164 1 491 490 492 +165 1 494 493 495 +166 1 497 496 498 +167 1 500 499 501 +168 1 503 502 504 +169 1 506 505 507 +170 1 509 508 510 +171 1 512 511 513 +172 1 515 514 516 +173 1 518 517 519 +174 1 521 520 522 +175 1 524 523 525 +176 1 527 526 528 +177 1 530 529 531 +178 1 533 532 534 +179 1 536 535 537 +180 1 539 538 540 +181 1 542 541 543 +182 1 545 544 546 +183 1 548 547 549 +184 1 551 550 552 +185 1 554 553 555 +186 1 557 556 558 +187 1 560 559 561 +188 1 563 562 564 +189 1 566 565 567 +190 1 569 568 570 +191 1 572 571 573 +192 1 575 574 576 +193 1 578 577 579 +194 1 581 580 582 +195 1 584 583 585 +196 1 587 586 588 +197 1 590 589 591 +198 1 593 592 594 +199 1 596 595 597 +200 1 599 598 600 +201 1 602 601 603 +202 1 605 604 606 +203 1 608 607 609 +204 1 611 610 612 +205 1 614 613 615 +206 1 617 616 618 +207 1 620 619 621 +208 1 623 622 624 +209 1 626 625 627 +210 1 629 628 630 +211 1 632 631 633 +212 1 635 634 636 +213 1 638 637 639 +214 1 641 640 642 +215 1 644 643 645 +216 1 647 646 648 + +Bond Coeffs + +1 0.9572 556.85 -1419.9675 2112.20165625 + +Angle Coeffs + +1 0 108.5 48.7 -39.064262472 8.95286947775 -6.41202044508 11.5462823034 + +Tinker Types + +1 1 +2 2 +3 2 +4 1 +5 2 +6 2 +7 1 +8 2 +9 2 +10 1 +11 2 +12 2 +13 1 +14 2 +15 2 +16 1 +17 2 +18 2 +19 1 +20 2 +21 2 +22 1 +23 2 +24 2 +25 1 +26 2 +27 2 +28 1 +29 2 +30 2 +31 1 +32 2 +33 2 +34 1 +35 2 +36 2 +37 1 +38 2 +39 2 +40 1 +41 2 +42 2 +43 1 +44 2 +45 2 +46 1 +47 2 +48 2 +49 1 +50 2 +51 2 +52 1 +53 2 +54 2 +55 1 +56 2 +57 2 +58 1 +59 2 +60 2 +61 1 +62 2 +63 2 +64 1 +65 2 +66 2 +67 1 +68 2 +69 2 +70 1 +71 2 +72 2 +73 1 +74 2 +75 2 +76 1 +77 2 +78 2 +79 1 +80 2 +81 2 +82 1 +83 2 +84 2 +85 1 +86 2 +87 2 +88 1 +89 2 +90 2 +91 1 +92 2 +93 2 +94 1 +95 2 +96 2 +97 1 +98 2 +99 2 +100 1 +101 2 +102 2 +103 1 +104 2 +105 2 +106 1 +107 2 +108 2 +109 1 +110 2 +111 2 +112 1 +113 2 +114 2 +115 1 +116 2 +117 2 +118 1 +119 2 +120 2 +121 1 +122 2 +123 2 +124 1 +125 2 +126 2 +127 1 +128 2 +129 2 +130 1 +131 2 +132 2 +133 1 +134 2 +135 2 +136 1 +137 2 +138 2 +139 1 +140 2 +141 2 +142 1 +143 2 +144 2 +145 1 +146 2 +147 2 +148 1 +149 2 +150 2 +151 1 +152 2 +153 2 +154 1 +155 2 +156 2 +157 1 +158 2 +159 2 +160 1 +161 2 +162 2 +163 1 +164 2 +165 2 +166 1 +167 2 +168 2 +169 1 +170 2 +171 2 +172 1 +173 2 +174 2 +175 1 +176 2 +177 2 +178 1 +179 2 +180 2 +181 1 +182 2 +183 2 +184 1 +185 2 +186 2 +187 1 +188 2 +189 2 +190 1 +191 2 +192 2 +193 1 +194 2 +195 2 +196 1 +197 2 +198 2 +199 1 +200 2 +201 2 +202 1 +203 2 +204 2 +205 1 +206 2 +207 2 +208 1 +209 2 +210 2 +211 1 +212 2 +213 2 +214 1 +215 2 +216 2 +217 1 +218 2 +219 2 +220 1 +221 2 +222 2 +223 1 +224 2 +225 2 +226 1 +227 2 +228 2 +229 1 +230 2 +231 2 +232 1 +233 2 +234 2 +235 1 +236 2 +237 2 +238 1 +239 2 +240 2 +241 1 +242 2 +243 2 +244 1 +245 2 +246 2 +247 1 +248 2 +249 2 +250 1 +251 2 +252 2 +253 1 +254 2 +255 2 +256 1 +257 2 +258 2 +259 1 +260 2 +261 2 +262 1 +263 2 +264 2 +265 1 +266 2 +267 2 +268 1 +269 2 +270 2 +271 1 +272 2 +273 2 +274 1 +275 2 +276 2 +277 1 +278 2 +279 2 +280 1 +281 2 +282 2 +283 1 +284 2 +285 2 +286 1 +287 2 +288 2 +289 1 +290 2 +291 2 +292 1 +293 2 +294 2 +295 1 +296 2 +297 2 +298 1 +299 2 +300 2 +301 1 +302 2 +303 2 +304 1 +305 2 +306 2 +307 1 +308 2 +309 2 +310 1 +311 2 +312 2 +313 1 +314 2 +315 2 +316 1 +317 2 +318 2 +319 1 +320 2 +321 2 +322 1 +323 2 +324 2 +325 1 +326 2 +327 2 +328 1 +329 2 +330 2 +331 1 +332 2 +333 2 +334 1 +335 2 +336 2 +337 1 +338 2 +339 2 +340 1 +341 2 +342 2 +343 1 +344 2 +345 2 +346 1 +347 2 +348 2 +349 1 +350 2 +351 2 +352 1 +353 2 +354 2 +355 1 +356 2 +357 2 +358 1 +359 2 +360 2 +361 1 +362 2 +363 2 +364 1 +365 2 +366 2 +367 1 +368 2 +369 2 +370 1 +371 2 +372 2 +373 1 +374 2 +375 2 +376 1 +377 2 +378 2 +379 1 +380 2 +381 2 +382 1 +383 2 +384 2 +385 1 +386 2 +387 2 +388 1 +389 2 +390 2 +391 1 +392 2 +393 2 +394 1 +395 2 +396 2 +397 1 +398 2 +399 2 +400 1 +401 2 +402 2 +403 1 +404 2 +405 2 +406 1 +407 2 +408 2 +409 1 +410 2 +411 2 +412 1 +413 2 +414 2 +415 1 +416 2 +417 2 +418 1 +419 2 +420 2 +421 1 +422 2 +423 2 +424 1 +425 2 +426 2 +427 1 +428 2 +429 2 +430 1 +431 2 +432 2 +433 1 +434 2 +435 2 +436 1 +437 2 +438 2 +439 1 +440 2 +441 2 +442 1 +443 2 +444 2 +445 1 +446 2 +447 2 +448 1 +449 2 +450 2 +451 1 +452 2 +453 2 +454 1 +455 2 +456 2 +457 1 +458 2 +459 2 +460 1 +461 2 +462 2 +463 1 +464 2 +465 2 +466 1 +467 2 +468 2 +469 1 +470 2 +471 2 +472 1 +473 2 +474 2 +475 1 +476 2 +477 2 +478 1 +479 2 +480 2 +481 1 +482 2 +483 2 +484 1 +485 2 +486 2 +487 1 +488 2 +489 2 +490 1 +491 2 +492 2 +493 1 +494 2 +495 2 +496 1 +497 2 +498 2 +499 1 +500 2 +501 2 +502 1 +503 2 +504 2 +505 1 +506 2 +507 2 +508 1 +509 2 +510 2 +511 1 +512 2 +513 2 +514 1 +515 2 +516 2 +517 1 +518 2 +519 2 +520 1 +521 2 +522 2 +523 1 +524 2 +525 2 +526 1 +527 2 +528 2 +529 1 +530 2 +531 2 +532 1 +533 2 +534 2 +535 1 +536 2 +537 2 +538 1 +539 2 +540 2 +541 1 +542 2 +543 2 +544 1 +545 2 +546 2 +547 1 +548 2 +549 2 +550 1 +551 2 +552 2 +553 1 +554 2 +555 2 +556 1 +557 2 +558 2 +559 1 +560 2 +561 2 +562 1 +563 2 +564 2 +565 1 +566 2 +567 2 +568 1 +569 2 +570 2 +571 1 +572 2 +573 2 +574 1 +575 2 +576 2 +577 1 +578 2 +579 2 +580 1 +581 2 +582 2 +583 1 +584 2 +585 2 +586 1 +587 2 +588 2 +589 1 +590 2 +591 2 +592 1 +593 2 +594 2 +595 1 +596 2 +597 2 +598 1 +599 2 +600 2 +601 1 +602 2 +603 2 +604 1 +605 2 +606 2 +607 1 +608 2 +609 2 +610 1 +611 2 +612 2 +613 1 +614 2 +615 2 +616 1 +617 2 +618 2 +619 1 +620 2 +621 2 +622 1 +623 2 +624 2 +625 1 +626 2 +627 2 +628 1 +629 2 +630 2 +631 1 +632 2 +633 2 +634 1 +635 2 +636 2 +637 1 +638 2 +639 2 +640 1 +641 2 +642 2 +643 1 +644 2 +645 2 +646 1 +647 2 +648 2 diff --git a/examples/amoeba/data.water_dimer.amoeba b/examples/amoeba/data.water_dimer.amoeba new file mode 100644 index 0000000000..591d081268 --- /dev/null +++ b/examples/amoeba/data.water_dimer.amoeba @@ -0,0 +1,54 @@ +LAMMPS data file created from Tinker water_dimer.xyz and water03.prm files + +6 atoms +4 bonds +2 angles +2 atom types +1 bond types +1 angle types +-1.463996 0.933234 xlo xhi +-0.756549 0.75612 ylo yhi +-0.009705 2.935934 zlo zhi + +Masses + +1 15.995 +2 1.008 + +Atoms + +1 1 1 0 -0.024616 -0.001154 -0.003748 +2 1 2 0 -0.244211 -0.000666 0.933978 +3 1 2 0 0.932234 -0.000406 -0.008705 +4 2 1 0 -0.892721 0.000120 2.773674 +5 2 2 0 -1.462996 0.755120 2.933870 +6 2 2 0 -1.461809 -0.755549 2.934934 + +Bonds + +1 1 1 2 +2 1 1 3 +3 1 4 5 +4 1 4 6 + +Angles + +1 1 2 1 3 +2 1 5 4 6 + +Bond Coeffs + +1 556.85 0.9572 + +Angle Coeffs + +1 48.70 108.50 + +Tinker Types + +1 1 1 +2 2 1 +3 2 1 +4 1 2 +5 2 2 +6 2 2 diff --git a/examples/amoeba/data.water_dimer.hippo b/examples/amoeba/data.water_dimer.hippo new file mode 100644 index 0000000000..875c90bc55 --- /dev/null +++ b/examples/amoeba/data.water_dimer.hippo @@ -0,0 +1,54 @@ +LAMMPS data file created from Tinker water_dimer.xyz and water19.prm files + +6 atoms +4 bonds +2 angles +2 atom types +1 bond types +1 angle types +-1.463996 0.933234 xlo xhi +-0.756549 0.75612 ylo yhi +-0.009705 2.935934 zlo zhi + +Masses + +1 15.999 +2 1.008 + +Atoms + +1 1 1 0 -0.024616 -0.001154 -0.003748 +2 1 2 0 -0.244211 -0.000666 0.933978 +3 1 2 0 0.932234 -0.000406 -0.008705 +4 2 1 0 -0.892721 0.000120 2.773674 +5 2 2 0 -1.462996 0.755120 2.933870 +6 2 2 0 -1.461809 -0.755549 2.934934 + +Bonds + +1 1 1 2 +2 1 1 3 +3 1 4 5 +4 1 4 6 + +Angles + +1 1 2 1 3 +2 1 5 4 6 + +Bond Coeffs + +1 556.85 0.9572 + +Angle Coeffs + +1 48.70 107.70 + +Tinker Types + +1 1 1 +2 2 1 +3 2 1 +4 1 2 +5 2 2 +6 2 2 diff --git a/examples/amoeba/data.water_hexamer.amoeba b/examples/amoeba/data.water_hexamer.amoeba new file mode 100644 index 0000000000..c20f81e3ed --- /dev/null +++ b/examples/amoeba/data.water_hexamer.amoeba @@ -0,0 +1,90 @@ +LAMMPS data file created from Tinker water_hexamer.xyz and water03.prm files + +18 atoms +12 bonds +6 angles +2 atom types +1 bond types +1 angle types +-2.517835 2.675716 xlo xhi +-1.523041 2.01883 ylo yhi +-1.734766 2.220847 zlo zhi + +Masses + +1 15.995 +2 1.008 + +Atoms + +1 1 1 0 -1.502169 -0.191359 1.434927 +2 1 2 0 -0.601054 -0.596972 1.553718 +3 1 2 0 -2.006698 -0.422327 2.219847 +4 2 1 0 -1.744575 -0.382348 -1.309144 +5 2 2 0 -1.888941 -0.479653 -0.347624 +6 2 2 0 -2.516835 -0.766765 -1.733766 +7 3 1 0 -0.560409 2.017830 -0.121984 +8 3 2 0 -0.947720 1.533567 0.625228 +9 3 2 0 -0.989831 1.592736 -0.877419 +10 4 1 0 0.964803 -1.165765 1.439987 +11 4 2 0 0.979557 -1.522041 0.527833 +12 4 2 0 1.542224 -0.393692 1.344373 +13 5 1 0 0.974705 -1.401503 -1.335970 +14 5 2 0 0.065161 -1.118951 -1.522886 +15 5 2 0 1.470709 -0.570933 -1.277710 +16 6 1 0 2.002280 1.057824 -0.124502 +17 6 2 0 1.141637 1.532266 -0.140121 +18 6 2 0 2.674716 1.735342 -0.237995 + +Bonds + +1 1 1 2 +2 1 1 3 +3 1 4 5 +4 1 4 6 +5 1 7 8 +6 1 7 9 +7 1 10 11 +8 1 10 12 +9 1 13 14 +10 1 13 15 +11 1 16 17 +12 1 16 18 + +Angles + +1 1 2 1 3 +2 1 5 4 6 +3 1 8 7 9 +4 1 11 10 12 +5 1 14 13 15 +6 1 17 16 18 + +Bond Coeffs + +1 556.85 0.9572 + +Angle Coeffs + +1 48.70 108.50 + +Tinker Types + +1 1 1 +2 2 1 +3 2 1 +4 1 2 +5 2 2 +6 2 2 +7 1 3 +8 2 3 +9 2 3 +10 1 4 +11 2 4 +12 2 4 +13 1 5 +14 2 5 +15 2 5 +16 1 6 +17 2 6 +18 2 6 diff --git a/examples/amoeba/data.water_hexamer.hippo b/examples/amoeba/data.water_hexamer.hippo new file mode 100644 index 0000000000..d83df2122a --- /dev/null +++ b/examples/amoeba/data.water_hexamer.hippo @@ -0,0 +1,90 @@ +LAMMPS data file created from Tinker water_hexamer.xyz and water19.prm files + +18 atoms +12 bonds +6 angles +2 atom types +1 bond types +1 angle types +-2.517835 2.675716 xlo xhi +-1.523041 2.01883 ylo yhi +-1.734766 2.220847 zlo zhi + +Masses + +1 15.999 +2 1.008 + +Atoms + +1 1 1 0 -1.502169 -0.191359 1.434927 +2 1 2 0 -0.601054 -0.596972 1.553718 +3 1 2 0 -2.006698 -0.422327 2.219847 +4 2 1 0 -1.744575 -0.382348 -1.309144 +5 2 2 0 -1.888941 -0.479653 -0.347624 +6 2 2 0 -2.516835 -0.766765 -1.733766 +7 3 1 0 -0.560409 2.017830 -0.121984 +8 3 2 0 -0.947720 1.533567 0.625228 +9 3 2 0 -0.989831 1.592736 -0.877419 +10 4 1 0 0.964803 -1.165765 1.439987 +11 4 2 0 0.979557 -1.522041 0.527833 +12 4 2 0 1.542224 -0.393692 1.344373 +13 5 1 0 0.974705 -1.401503 -1.335970 +14 5 2 0 0.065161 -1.118951 -1.522886 +15 5 2 0 1.470709 -0.570933 -1.277710 +16 6 1 0 2.002280 1.057824 -0.124502 +17 6 2 0 1.141637 1.532266 -0.140121 +18 6 2 0 2.674716 1.735342 -0.237995 + +Bonds + +1 1 1 2 +2 1 1 3 +3 1 4 5 +4 1 4 6 +5 1 7 8 +6 1 7 9 +7 1 10 11 +8 1 10 12 +9 1 13 14 +10 1 13 15 +11 1 16 17 +12 1 16 18 + +Angles + +1 1 2 1 3 +2 1 5 4 6 +3 1 8 7 9 +4 1 11 10 12 +5 1 14 13 15 +6 1 17 16 18 + +Bond Coeffs + +1 556.85 0.9572 + +Angle Coeffs + +1 48.70 107.70 + +Tinker Types + +1 1 1 +2 2 1 +3 2 1 +4 1 2 +5 2 2 +6 2 2 +7 1 3 +8 2 3 +9 2 3 +10 1 4 +11 2 4 +12 2 4 +13 1 5 +14 2 5 +15 2 5 +16 1 6 +17 2 6 +18 2 6 diff --git a/examples/amoeba/hippo_water.key b/examples/amoeba/hippo_water.key new file mode 100644 index 0000000000..a61b83875b --- /dev/null +++ b/examples/amoeba/hippo_water.key @@ -0,0 +1,9 @@ +parameters ./hippo.prm + +digits 8 + +cutoff 10 +taper 8 + +polar-eps 1e-5 +usolve-diag 1.0 \ No newline at end of file diff --git a/examples/amoeba/hippo_water.prm b/examples/amoeba/hippo_water.prm new file mode 100644 index 0000000000..4962dc1758 --- /dev/null +++ b/examples/amoeba/hippo_water.prm @@ -0,0 +1,319 @@ + + ############################## + ## ## + ## Force Field Definition ## + ## ## + ############################## + + +forcefield HIPPO-WATER-2019 + +bond-cubic -2.55 +bond-quartic 3.793125 +angle-cubic -0.014 +angle-quartic 0.000056 +angle-pentic -0.0000007 +angle-sextic 0.000000022 +opbendtype ALLINGER +opbend-cubic -0.014 +opbend-quartic 0.000056 +opbend-pentic -0.0000007 +opbend-sextic 0.000000022 +torsionunit 0.5 +dielectric 1.0 +polarization MUTUAL +rep-12-scale 0.0 +rep-13-scale 0.0 +rep-14-scale 1.0 +rep-15-scale 1.0 +disp-12-scale 0.0 +disp-13-scale 0.0 +disp-14-scale 0.4 +#disp-15-scale 0.8 +mpole-12-scale 0.0 +mpole-13-scale 0.0 +mpole-14-scale 0.4 +#mpole-15-scale 0.8 +polar-12-scale 0.0 +polar-13-scale 0.0 +polar-14-scale 1.0 +polar-15-scale 1.0 +polar-12-intra 0.0 +polar-13-intra 0.0 +polar-14-intra 0.5 +polar-15-intra 1.0 +direct-11-scale 0.0 +direct-12-scale 1.0 +direct-13-scale 1.0 +direct-14-scale 1.0 +mutual-11-scale 1.0 +mutual-12-scale 1.0 +mutual-13-scale 1.0 +mutual-14-scale 1.0 +induce-12-scale 0.2 +induce-13-scale 1.0 +induce-14-scale 1.0 +induce-15-scale 1.0 + + + ############################# + ## ## + ## Literature References ## + ## ## + ############################# + + +This is a preliminary parameter set for water based on the HIPPO +(Hydrogen-like Intermolecular Polarizable Potential) force field. +It uses terms describing charge penetration, damped dispersion, and +anisotropic repulsion as per the papers below. The parameters are as +of 13 May 2019 and are from Roseane dos Reis Silva and Josh Rackers +in the Ponder lab at Washington University. These parameter values +are under development and are subject to change. + +J. A. Rackers, Q. Wang, C. Liu, J.-P. Piquemal, P. Ren and J. W. Ponder, +An Optimized Charge Penetration Model for Use with the AMOEBA Force Field, +Physical Chemistry Chemical Physics, 19, 276-291 (2017) + +J. A. Rackers, C. Liu, P. Ren and J. W. Ponder, A Physically Grounded +Damped Dispersion Model with Particle Mesh Ewald Summation, Journal +of Chemical Physics, 149, 084115 (2018) + +J. A. Rackers and J. W. Ponder, Classical Pauli Repulsion: An Anisotropic, +Atomic Multipole Model, Journal of Chemical Physics, 150, 084104 (2019) + + + ############################# + ## ## + ## Atom Type Definitions ## + ## ## + ############################# + + +atom 1 1 O "HIPPO Water O" 8 15.999 2 +atom 2 2 H "HIPPO Water H" 1 1.008 1 + + + ################################## + ## ## + ## Bond Stretching Parameters ## + ## ## + ################################## + + +bond 1 2 556.85 0.9572 !! all + + + ################################ + ## ## + ## Angle Bending Parameters ## + ## ## + ################################ + + +#angle 2 1 2 48.70 108.50 !! orig +#angle 2 1 2 48.70 107.70 !! 13 +#angle 2 1 2 48.70 107.70 !! 12 +#angle 2 1 2 48.70 107.70 !! 16t-i2 +#angle 2 1 2 48.70 107.70 !! 16t-i6 +#angle 2 1 2 48.70 107.70 !! 17t-i3 +angle 2 1 2 48.70 107.70 !! 17t-i6 + + + ################################## + ## ## + ## Pauli Repulsion Parameters ## + ## ## + ################################## + + +#repulsion 1 2.8478 4.6069 3.3353 !! orig +#repulsion 2 2.0560 4.8356 0.7423 !! orig +#repulsion 1 2.7716 4.4097 3.3789 !! 13 +#repulsion 2 2.0410 4.8567 0.6592 !! 13 +#repulsion 1 2.7875 4.4310 3.3914 !! 12 +#repulsion 2 2.0510 4.8314 0.6557 !! 12 +#repulsion 1 2.8604 4.5590 3.3554 !! t16-i2 +#repulsion 2 2.0508 4.8497 0.7264 !! t16-i2 +#repulsion 1 2.8618 4.4770 3.3790 !! t16-i6 +#repulsion 2 2.0658 4.9052 0.6831 !! t16-i6 +#repulsion 1 2.8644 4.4964 3.3594 !! t17-i3 +#repulsion 2 2.0605 4.8965 0.6958 !! t17-i3 +repulsion 1 2.8758 4.4394 3.3883 !! t17-i6 +repulsion 2 2.0610 4.9367 0.6505 !! t17-i6 + + + ############################# + ## ## + ## Dispersion Parameters ## + ## ## + ############################# + + +#dispersion 1 16.4682 4.4288 !! orig +#dispersion 2 2.9470 4.9751 !! orig +#dispersion 1 17.0790 4.3977 !! 13 +#dispersion 2 4.2262 4.9255 !! 13 +#dispersion 1 17.0607 4.3872 !! 12 +#dispersion 2 4.2382 4.9542 !! 12 +#dispersion 1 16.6803 4.4470 !! t16-i2 +#dispersion 2 3.4415 4.9267 !! t16-i2 +#dispersion 1 16.7807 4.4427 !! t16-i6 +#dispersion 2 3.8508 4.9261 !! t16-i6 +#dispersion 1 16.6579 4.2763 !! t17-i3 +#dispersion 2 3.2999 4.9597 !! t17-i3 +dispersion 1 16.7190 4.3418 !! t17-i6 +dispersion 2 3.4239 4.9577 !! t17-i6 + + + ################################### + ## ## + ## Atomic Multipole Parameters ## + ## ## + ################################### + + +!! orig +#multipole 1 -2 -2 -0.38280 + 0.00000 0.00000 0.05477 + 0.69866 + 0.00000 -0.60471 + 0.00000 0.00000 -0.09395 +#multipole 2 1 2 0.19140 + 0.00000 0.00000 -0.20097 + 0.03881 + 0.00000 0.02214 + 0.00000 0.00000 -0.06095 +!! 13 +#multipole 1 -2 -2 -0.38296 + 0.00000 0.00000 0.05086 + 0.70053 + 0.00000 -0.61138 + 0.00000 0.00000 -0.08915 +#multipole 2 1 2 0.19148 + 0.00000 0.00000 -0.20142 + 0.06672 + 0.00000 0.04168 + 0.01245 0.00000 -0.10840 +!! 12 +#multipole 1 -2 -2 -0.38468 + 0.00000 0.00000 0.05069 + 0.70076 + 0.00000 -0.61593 + 0.00000 0.00000 -0.08483 +#multipole 2 1 2 0.19234 + 0.00000 0.00000 -0.20236 + 0.06136 + 0.00000 0.04166 + 0.00591 0.00000 -0.10302 +!! t16-i2 +#multipole 1 -2 -2 -0.38236 + 0.00000 0.00000 0.05488 + 0.69693 + 0.00000 -0.60514 + 0.00000 0.00000 -0.09179 +#multipole 2 1 2 0.19118 + 0.00000 0.00000 -0.20081 + 0.04614 + 0.00000 0.02258 + 0.00000 0.00000 -0.07172 +!! t16-i6 +#multipole 1 -2 -2 -0.37854 + 0.00000 0.00000 0.05439 + 0.68442 + 0.00000 -0.61857 + 0.00000 0.00000 -0.06585 +#multipole 2 1 2 0.18927 + 0.00000 0.00000 -0.19918 + 0.05839 + 0.00000 0.03699 + 0.00683 0.00000 -0.09538 +!! t17-i3 +#multipole 1 -2 -2 -0.37944 + 0.00000 0.00000 0.05496 + 0.69091 + 0.00000 -0.60566 + 0.00000 0.00000 -0.08525 +#multipole 2 1 2 0.18972 + 0.00000 0.00000 -0.20057 + 0.05030 + 0.00000 0.03290 + 0.00187 0.00000 -0.08320 +!! t17-i6 +multipole 1 -2 -2 -0.37724 + 0.00000 0.00000 0.05410 + 0.68565 + 0.00000 -0.60559 + 0.00000 0.00000 -0.08006 +multipole 2 1 2 0.18862 + 0.00000 0.00000 -0.19902 + 0.06206 + 0.00000 0.04341 + 0.00709 0.00000 -0.10547 + + + ##################################### + ## ## + ## Charge Penetration Parameters ## + ## ## + ##################################### + + +#chgpen 1 6.0000 4.4288 !! orig +#chgpen 2 1.0000 4.9751 !! orig +#chgpen 1 6.0000 4.3977 !! 13 +#chgpen 2 1.0000 4.9255 !! 13 +#chgpen 1 6.0000 4.3872 !! 12 +#chgpen 2 1.0000 4.9542 !! 12 +#chgpen 1 6.0000 4.4470 !! t16-i2 +#chgpen 2 1.0000 4.9767 !! t16-i2 +#chgpen 1 6.0000 4.4427 !! t16-i6 +#chgpen 2 1.0000 4.9261 !! t16-i6 +#chgpen 1 6.0000 4.3763 !! t17-i3 +#chgpen 2 1.0000 4.9597 !! t17-i3 +chgpen 1 6.0000 4.3418 !! t17-i6 +chgpen 2 1.0000 4.9577 !! t17-i6 + + + ######################################## + ## ## + ## Dipole Polarizability Parameters ## + ## ## + ######################################## + + +#polarize 1 0.7482 2 !! orig +#polarize 2 0.3703 1 !! orig +#polarize 1 0.7448 2 !! 13 +#polarize 2 0.3897 1 !! 13 +#polarize 1 0.7442 2 !! 12 +#polarize 2 0.3874 1 !! 12 +#polarize 1 0.7499 2 !! t16-i2 +#polarize 2 0.3706 1 !! t16-i2 +#polarize 1 0.7403 2 !! t16-i6 +#polarize 2 0.3774 1 !! t16-i6 +#polarize 1 0.7416 2 !! t17-i3 +#polarize 2 0.3670 1 !! t17-i3 +polarize 1 0.7332 2 !! t17-i6 +polarize 2 0.3691 1 !! t17-i6 + + + ################################## + ## ## + ## Charge Transfer Parameters ## + ## ## + ################################## + + +#chgtrn 1 3.5788 0.0000 !! orig +#chgtrn 2 0.0000 3.3292 !1 orig +#chgtrn 1 3.5856 0.0000 !! 13 +#chgtrn 2 0.0000 3.3482 !! 13 +#chgtrn 1 3.5867 0.0000 !! t16-i2 +#chgtrn 2 0.0000 3.3105 !! t16-i2 +#chgtrn 1 3.5812 0.0000 !! t16-i6 +#chgtrn 2 0.0000 3.2909 !! t16-i6 +#chgtrn 1 3.5762 0.0000 !! t17-i3 +#chgtrn 2 0.0000 3.2881 !! t17-i3 +chgtrn 1 3.5551 0.0000 !! t17-i6 +chgtrn 2 0.0000 3.2812 !! t17-i6 diff --git a/examples/amoeba/in.ubiquitin b/examples/amoeba/in.ubiquitin new file mode 100644 index 0000000000..7f61edabab --- /dev/null +++ b/examples/amoeba/in.ubiquitin @@ -0,0 +1,105 @@ +# default cmd-line variable settings + +variable a index "" +variable diff index 0 + +units real +boundary p p p +atom_modify sort 0 0.0 +comm_modify cutoff 5.0 + +atom_style amoeba +special_bonds lj/coul 0.5 0.5 0.5 one/five yes + +bond_style class2 +angle_style amoeba +#dihedral_style nharmonic +dihedral_style none + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom & + i_amgroup i_ired i_xaxis i_yaxis i_zaxis d_pval ghost yes +fix extra2 all property/atom i_polaxe + +read_data data.${struc}.angles fix amtype NULL "Tinker Types" +#read_data data.watersmall fix amtype NULL "Tinker Types" +#read_data data.water_hexamer fix amtype NULL "Tinker Types" + +# insure all 1-2,1-3,1-4,1-5 are in Tinker neigh list + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes + +# force field terms +# depends on 2 command-line variables +# ff = amoeba or hippo, a = args for pair_style + +if "${ff} == amoeba" then & +"pair_style amoeba $a" & +"pair_coeff * * amoeba.prm amoeba.key" + +if "${ff} == hippo" then & +"pair_style hippo $a" & +"pair_coeff * * hippo.prm hippo.key" + +if "${ff} == amoeba_direct" then & +"pair_style amoeba $a" & +"pair_coeff * * amoeba_direct.prm amoeba_direct.key" + +if "${ff} == hippo_direct" then & +"pair_style hippo $a" & +"pair_coeff * * hippo_direct.prm hippo_direct.key" + +if "${ff} == amoeba_opt" then & +"pair_style amoeba $a" & +"pair_coeff * * amoeba.prm amoeba_opt.key" + +if "${ff} == hippo_opt" then & +"pair_style hippo $a" & +"pair_coeff * * hippo.prm hippo_opt.key" + +# optional turn off angle and dihedral + +#angle_style none +dihedral_style none + +# numeric difference of forces + +#compute nd all pe +#fix nd all numdiff ${diff} 1.0e-5 nd +#variable dx atom abs(fx+f_nd[1]) +#variable dy atom abs(fy+f_nd[2]) +#variable dz atom abs(fz+f_nd[3]) +#compute rd all reduce max v_dx v_dy v_dz + +# setup force components this way so can dump them + +fix fhal all store/state 0 fx fy fz +fix frepulse all store/state 0 fx fy fz +fix fdisp all store/state 0 fx fy fz +fix fpolar all store/state 0 fx fy fz +fix fmpole all store/state 0 fx fy fz +fix fqxfer all store/state 0 fx fy fz + +dump 1 all custom 1 ${dumpfile} id type x y z fx fy fz & +# f_fhal[1] f_fhal[2] f_fhal[3] & +# f_fdisp[1] f_fdisp[2] f_fdisp[3] & +# f_frepulse[1] f_frepulse[2] f_frepulse[3] & +# f_fpolar[1] f_fpolar[2] f_fpolar[3] & +# f_fmpole[1] f_fmpole[2] f_fmpole[3] & +# f_fqxfer[1] f_fqxfer[2] f_fqxfer[3] +# f_nd[1] f_nd[2] f_nd[3] + +dump_modify 1 format float "%20.16g" sort id + +compute virial all pressure NULL virial + +# thermo output + +thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] #c_rd[*] +thermo_modify format float "%20.16g" + +# 0-step run + +run 0 diff --git a/examples/amoeba/in.water_box b/examples/amoeba/in.water_box new file mode 100644 index 0000000000..7175ec6750 --- /dev/null +++ b/examples/amoeba/in.water_box @@ -0,0 +1,106 @@ +# test of HIPPO water dimer system + +# default cmd-line variable settings + +variable a index "" +variable diff index 0 + +units real +atom_style full +boundary p p p +atom_modify sort 0 0.0 + +atom_style amoeba +special_bonds lj/coul 0.5 0.5 0.5 one/five yes + +bond_style class2 +angle_style amoeba + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom & + i_amgroup i_ired i_xaxis i_yaxis i_zaxis d_pval ghost yes +fix extra2 all property/atom i_polaxe + +read_data data.${struc}.angles fix amtype NULL "Tinker Types" +#read_data data.watersmall fix amtype NULL "Tinker Types" +#read_data data.water_hexamer fix amtype NULL "Tinker Types" + +# insure all 1-2,1-3,1-4 are in Tinker neigh list + +special_bonds lj/coul 0.5 0.5 0.5 + +# force field terms +# depends on 2 command-line variables +# ff = amoeba or hippo, a = args for pair_style + +if "${ff} == amoeba" then & +"pair_style amoeba $a" & +"pair_coeff * * amoeba.prm amoeba.key" + +if "${ff} == hippo" then & +"pair_style hippo $a" & +"pair_coeff * * hippo.prm hippo.key" + +if "${ff} == amoeba_direct" then & +"pair_style amoeba $a" & +"pair_coeff * * amoeba_direct.prm amoeba_direct.key" + +if "${ff} == hippo_direct" then & +"pair_style hippo $a" & +"pair_coeff * * hippo_direct.prm hippo_direct.key" + +if "${ff} == amoeba_opt" then & +"pair_style amoeba $a" & +"pair_coeff * * amoeba.prm amoeba_opt.key" + +if "${ff} == hippo_opt" then & +"pair_style hippo $a" & +"pair_coeff * * hippo.prm hippo_opt.key" + + +# turn off bond/angle interactions for now + +#bond_style none +#angle_style none + +# numeric difference of forces + +#compute nd all pe +#fix nd all numdiff ${diff} 1.0e-5 nd +#variable dx atom abs(fx+f_nd[1]) +#variable dy atom abs(fy+f_nd[2]) +#variable dz atom abs(fz+f_nd[3]) +#compute rd all reduce max v_dx v_dy v_dz + +# setup force components this way so can dump them + +fix fhal all store/state 0 fx fy fz +fix frepulse all store/state 0 fx fy fz +fix fdisp all store/state 0 fx fy fz +fix fpolar all store/state 0 fx fy fz +fix fmpole all store/state 0 fx fy fz +fix fqxfer all store/state 0 fx fy fz + +dump 1 all custom 1 ${dumpfile} id type x y z fx fy fz & +# f_fhal[1] f_fhal[2] f_fhal[3] & +# f_fdisp[1] f_fdisp[2] f_fdisp[3] & +# f_frepulse[1] f_frepulse[2] f_frepulse[3] & +# f_fpolar[1] f_fpolar[2] f_fpolar[3] & +# f_fmpole[1] f_fmpole[2] f_fmpole[3] & +# f_fqxfer[1] f_fqxfer[2] f_fqxfer[3] & +# f_nd[1] f_nd[2] f_nd[3] + +dump_modify 1 format float "%15.10g" sort id + +compute virial all pressure NULL virial + +# thermo output + +thermo_style custom step temp epair ebond eanble etotal press c_virial[*] #c_rd[*] +thermo_modify format float "%15.10g" + +# 0-step run + +run 0 diff --git a/examples/amoeba/in.water_dimer b/examples/amoeba/in.water_dimer new file mode 100644 index 0000000000..30b5dc71b2 --- /dev/null +++ b/examples/amoeba/in.water_dimer @@ -0,0 +1,104 @@ +# test of HIPPO water dimer system + +# default cmd-line variable settings + +variable a index "" +variable diff index 0 + +units real +atom_style full +boundary s s s + +atom_style amoeba +special_bonds lj/coul 0.5 0.5 0.5 one/five yes + +bond_style class2 +angle_style amoeba +dihedral_style none + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom & + i_amgroup i_ired i_xaxis i_yaxis i_zaxis d_pval ghost yes +fix extra2 all property/atom i_polaxe + +read_data data.${struc}.bonds fix amtype NULL "Tinker Types" +#read_data data.watersmall fix amtype NULL "Tinker Types" +#read_data data.water_hexamer fix amtype NULL "Tinker Types" + +# insure all 1-2,1-3,1-4 are in Tinker neigh list + +special_bonds lj/coul 0.5 0.5 0.5 + +# force field terms +# depends on 2 command-line variables +# ff = amoeba or hippo, a = args for pair_style + +if "${ff} == amoeba" then & +"pair_style amoeba $a" & +"pair_coeff * * amoeba.prm amoeba.key" + +if "${ff} == hippo" then & +"pair_style hippo $a" & +"pair_coeff * * hippo.prm hippo.key" + +if "${ff} == amoeba_direct" then & +"pair_style amoeba $a" & +"pair_coeff * * amoeba_direct.prm amoeba_direct.key" + +if "${ff} == hippo_direct" then & +"pair_style hippo $a" & +"pair_coeff * * hippo_direct.prm hippo_direct.key" + +if "${ff} == amoeba_opt" then & +"pair_style amoeba $a" & +"pair_coeff * * amoeba.prm amoeba_opt.key" + +if "${ff} == hippo_opt" then & +"pair_style hippo $a" & +"pair_coeff * * hippo.prm hippo_opt.key" + + +# turn off bond/angle interactions for now + +#bond_style none +#angle_style none + +# numeric difference of forces + +#compute nd all pe +#fix nd all numdiff ${diff} 1.0e-5 nd +#variable dx atom abs(fx+f_nd[1]) +#variable dy atom abs(fy+f_nd[2]) +#variable dz atom abs(fz+f_nd[3]) +#compute rd all reduce max v_dx v_dy v_dz + +# setup force components this way so can dump them + +fix fhal all store/state 0 fx fy fz +fix frepulse all store/state 0 fx fy fz +fix fdisp all store/state 0 fx fy fz +fix fpolar all store/state 0 fx fy fz +fix fmpole all store/state 0 fx fy fz +fix fqxfer all store/state 0 fx fy fz + +dump 1 all custom 1 ${dumpfile} id type fx fy fz & +# f_fhal[1] f_fhal[2] f_fhal[3] & +# f_fdisp[1] f_fdisp[2] f_fdisp[3] & +# f_frepulse[1] f_frepulse[2] f_frepulse[3] & +# f_fpolar[1] f_fpolar[2] f_fpolar[3] & +# f_fmpole[1] f_fmpole[2] f_fmpole[3] & +# f_fqxfer[1] f_fqxfer[2] f_fqxfer[3] & +# f_nd[1] f_nd[2] f_nd[3] + +dump_modify 1 format float "%15.10g" sort id + +# thermo output + +thermo_style custom step temp epair ebond eangle etotal press #c_rd[*] +thermo_modify format float "%15.10g" + +# 0-step run + +run 0 diff --git a/examples/amoeba/in.water_hexamer b/examples/amoeba/in.water_hexamer new file mode 100644 index 0000000000..580b8a6849 --- /dev/null +++ b/examples/amoeba/in.water_hexamer @@ -0,0 +1,103 @@ +# test of HIPPO water dimer system + +# default cmd-line variable settings + +variable a index "" +variable diff index 0 + +units real +atom_style full +boundary s s s + +atom_style amoeba +special_bonds lj/coul 0.5 0.5 0.5 one/five yes + +bond_style harmonic +angle_style harmonic + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom & + i_amgroup i_ired i_xaxis i_yaxis i_zaxis d_pval ghost yes +fix extra2 all property/atom i_polaxe + +read_data data.${struc} fix amtype NULL "Tinker Types" +#read_data data.watersmall fix amtype NULL "Tinker Types" +#read_data data.water_hexamer fix amtype NULL "Tinker Types" + +# insure all 1-2,1-3,1-4 are in Tinker neigh list + +special_bonds lj/coul 0.5 0.5 0.5 + +# force field terms +# depends on 2 command-line variables +# ff = amoeba or hippo, a = args for pair_style + +if "${ff} == amoeba" then & +"pair_style amoeba $a" & +"pair_coeff * * amoeba.prm amoeba.key" + +if "${ff} == hippo" then & +"pair_style hippo $a" & +"pair_coeff * * hippo.prm hippo.key" + +if "${ff} == amoeba_direct" then & +"pair_style amoeba $a" & +"pair_coeff * * amoeba_direct.prm amoeba_direct.key" + +if "${ff} == hippo_direct" then & +"pair_style hippo $a" & +"pair_coeff * * hippo_direct.prm hippo_direct.key" + +if "${ff} == amoeba_opt" then & +"pair_style amoeba $a" & +"pair_coeff * * amoeba.prm amoeba_opt.key" + +if "${ff} == hippo_opt" then & +"pair_style hippo $a" & +"pair_coeff * * hippo.prm hippo_opt.key" + + +# turn off bond/angle interactions for now + +bond_style none +angle_style none + +# numeric difference of forces + +#compute nd all pe +#fix nd all numdiff ${diff} 1.0e-5 nd +#variable dx atom abs(fx+f_nd[1]) +#variable dy atom abs(fy+f_nd[2]) +#variable dz atom abs(fz+f_nd[3]) +#compute rd all reduce max v_dx v_dy v_dz + +# setup force components this way so can dump them + +fix fhal all store/state 0 fx fy fz +fix frepulse all store/state 0 fx fy fz +fix fdisp all store/state 0 fx fy fz +fix fpolar all store/state 0 fx fy fz +fix fmpole all store/state 0 fx fy fz +fix fqxfer all store/state 0 fx fy fz + +dump 1 all custom 1 ${dumpfile} id type x y z fx fy fz & +# f_fhal[1] f_fhal[2] f_fhal[3] & +# f_fdisp[1] f_fdisp[2] f_fdisp[3] & +# f_frepulse[1] f_frepulse[2] f_frepulse[3] & +# f_fpolar[1] f_fpolar[2] f_fpolar[3] & +# f_fmpole[1] f_fmpole[2] f_fmpole[3] & +# f_fqxfer[1] f_fqxfer[2] f_fqxfer[3] & +# f_nd[1] f_nd[2] f_nd[3] + +dump_modify 1 format float "%15.10g" sort id + +# thermo output + +thermo_style custom step temp epair emol etotal press #c_rd[*] +thermo_modify format float "%15.10g" + +# 0-step run + +run 0 diff --git a/examples/amoeba/ubiquitin.xyz b/examples/amoeba/ubiquitin.xyz new file mode 100644 index 0000000000..95b82e9793 --- /dev/null +++ b/examples/amoeba/ubiquitin.xyz @@ -0,0 +1,9738 @@ + 9737 UBIQUITIN (AMOEBA PROTEIN + 2835 WATERS) + 1 N 9.963103 5.604761 0.008413 234 2 5 6 7 + 2 CA 9.595854 5.616857 -1.387669 8 1 3 8 9 + 3 C 8.190092 6.079015 -1.537478 9 2 4 20 + 4 O 7.228002 5.276741 -1.343729 11 3 + 5 H 9.248539 5.324856 0.671238 235 1 + 6 H 10.310756 6.543175 0.309331 235 1 + 7 H 10.709289 4.952168 0.170763 235 1 + 8 H 10.342605 6.385672 -1.876827 12 2 + 9 C 9.777424 4.134312 -1.928716 178 2 10 13 14 + 10 C 9.485635 3.817581 -3.412559 180 9 11 15 16 + 11 S 10.117567 2.116666 -3.905314 182 10 12 + 12 C 9.214556 1.102048 -2.698793 183 11 17 18 19 + 13 H 8.995937 3.481218 -1.313618 179 9 + 14 H 10.813555 3.756529 -1.729292 179 9 + 15 H 10.074410 4.479912 -4.109344 181 10 + 16 H 8.425285 3.844015 -3.623677 181 10 + 17 H 9.476005 1.466410 -1.683717 184 12 + 18 H 9.531462 0.065851 -2.728696 184 12 + 19 H 8.157703 1.221346 -2.837348 184 12 + 20 N 8.075651 7.407997 -1.589694 7 3 21 24 + 21 CA 6.846787 8.085212 -1.711474 8 20 22 25 26 + 22 C 6.189365 7.484141 -3.005186 9 21 23 37 + 23 O 6.734597 7.675309 -4.068223 11 22 + 24 HN 8.951370 7.929371 -1.808185 10 20 + 25 H 6.170991 7.786742 -0.821099 12 21 + 26 C 7.045430 9.684350 -1.731240 170 21 27 31 32 + 27 C 5.783147 10.543682 -1.755861 172 26 28 33 34 + 28 C 4.878227 10.489051 -3.011941 174 27 29 30 + 29 O 5.100354 11.293553 -3.954911 175 28 + 30 N 3.787647 9.697542 -2.965312 176 28 35 36 + 31 H 7.774130 9.919050 -2.476360 171 26 + 32 H 7.651586 10.027873 -0.831299 171 26 + 33 H 6.211664 11.592747 -1.874653 173 27 + 34 H 5.241990 10.447103 -0.794638 173 27 + 35 HN 3.649816 9.134508 -2.112027 177 30 + 36 HN 3.185263 9.534971 -3.811678 177 30 + 37 N 5.036494 6.768214 -2.882880 7 22 38 41 + 38 CA 4.174197 6.305367 -3.990075 8 37 39 42 43 + 39 C 2.728098 6.643573 -3.679890 9 38 40 56 + 40 O 2.485580 7.278505 -2.662964 11 39 + 41 HN 4.569007 6.922928 -2.037115 10 37 + 42 H 4.411152 6.930990 -4.873795 12 38 + 43 C 4.308955 4.772244 -4.223706 25 38 44 45 47 + 44 C 3.611944 3.837131 -3.115456 29 43 46 48 49 + 45 C 5.819814 4.327532 -4.394409 27 43 50 51 52 + 46 C 3.741844 2.375632 -3.462760 31 44 53 54 55 + 47 H 3.791883 4.511448 -5.208449 26 43 + 48 H 2.547744 4.084411 -3.073934 30 44 + 49 H 4.014866 4.138283 -2.115089 30 44 + 50 H 6.389594 4.495961 -3.449963 28 45 + 51 H 6.367709 4.976173 -5.128547 28 45 + 52 H 5.908880 3.195479 -4.756566 28 45 + 53 H 3.393827 2.185310 -4.536109 32 46 + 54 H 3.102312 1.694874 -2.887955 32 46 + 55 H 4.760146 2.000072 -3.426085 32 46 + 56 N 1.684147 6.367185 -4.575190 7 39 57 60 + 57 CA 0.304736 6.655628 -4.231748 8 56 58 61 62 + 58 C -0.626185 5.414986 -4.519968 9 57 59 76 + 59 O -0.188430 4.481000 -5.239972 11 58 + 60 HN 1.811341 5.682101 -5.345446 10 56 + 61 H 0.263980 6.686032 -3.118862 12 57 + 62 C -0.297187 7.876289 -4.967331 64 57 63 69 70 + 63 C 0.656467 9.081574 -5.199077 66 62 64 65 + 64 C 1.564880 9.231158 -6.344247 67 63 66 71 + 65 C 0.518242 10.180719 -4.311011 67 63 67 72 + 66 C 2.254905 10.428397 -6.564398 69 64 68 73 + 67 C 1.266077 11.295338 -4.552651 69 65 68 74 + 68 C 2.142006 11.455092 -5.583064 71 66 67 75 + 69 H -1.140556 8.280905 -4.296048 65 62 + 70 H -0.810414 7.566064 -5.884866 65 62 + 71 H 1.670266 8.406033 -7.077975 68 64 + 72 H -0.165699 10.178758 -3.490791 68 65 + 73 H 2.904650 10.539850 -7.451626 70 66 + 74 H 1.204400 12.095766 -3.710976 70 67 + 75 H 2.760015 12.463610 -5.750178 72 68 + 76 N -1.919463 5.547799 -4.105657 7 58 77 80 + 77 CA -3.045010 4.631011 -4.380927 8 76 78 81 82 + 78 C -4.206191 5.442932 -4.923986 9 77 79 92 + 79 O -4.727895 6.299647 -4.174539 11 78 + 80 HN -2.189033 6.454364 -3.576690 10 76 + 81 H -2.684685 3.831124 -5.207150 12 77 + 82 C -3.444418 3.799031 -3.130661 15 77 83 84 85 + 83 C -4.638073 2.796605 -3.426800 17 82 86 87 88 + 84 C -2.172636 3.025555 -2.692910 17 82 89 90 91 + 85 H -3.669812 4.518348 -2.290701 16 82 + 86 H -4.428840 2.137544 -4.376863 18 83 + 87 H -5.534299 3.436652 -3.543248 18 83 + 88 H -4.789185 2.176325 -2.494354 18 83 + 89 H -1.667617 3.522055 -1.846039 18 84 + 90 H -1.416445 2.861139 -3.471806 18 84 + 91 H -2.413054 1.986644 -2.328475 18 84 + 92 N -4.550673 5.196731 -6.274871 7 78 93 96 + 93 CA -5.820881 5.714130 -6.792896 8 92 94 97 98 + 94 C -6.901797 4.657281 -6.559257 9 93 95 114 + 95 O -6.707326 3.538748 -6.976520 11 94 + 96 HN -4.247417 4.330282 -6.731623 10 92 + 97 H -6.018895 6.628095 -6.157881 12 93 + 98 C -5.786797 6.030910 -8.386430 185 93 99 103 104 + 99 C -7.031253 6.879587 -8.916479 187 98 100 105 106 + 100 C -6.946629 7.328107 -10.409836 189 99 101 107 108 + 101 C -6.782582 6.224048 -11.537592 191 100 102 109 110 + 102 N -6.791739 6.775547 -12.918869 193 101 111 112 113 + 103 H -5.650656 5.119864 -8.896094 186 98 + 104 H -4.894535 6.632893 -8.720825 186 98 + 105 H -7.188700 7.743879 -8.218707 188 99 + 106 H -7.899583 6.225721 -8.760371 188 99 + 107 H -5.985957 7.986594 -10.510771 190 100 + 108 H -7.792216 7.961266 -10.639952 190 100 + 109 H -7.448325 5.332480 -11.448147 192 101 + 110 H -5.800269 5.666745 -11.336805 192 101 + 111 HN -5.991776 7.279636 -13.178670 194 102 + 112 HN -7.621495 7.404931 -13.058222 194 102 + 113 HN -6.983504 6.085979 -13.693073 194 102 + 114 N -8.069363 5.037776 -5.939754 7 94 115 118 + 115 CA -9.334342 4.259320 -5.870215 33 114 116 119 120 + 116 C -10.106400 4.390027 -7.235984 9 115 117 128 + 117 O -9.678872 5.138872 -8.064541 11 116 + 118 HN -8.065341 5.988423 -5.484094 10 114 + 119 H -9.057846 3.167719 -5.835950 12 115 + 120 C -10.266512 4.660993 -4.660344 38 115 121 122 123 + 121 OH -10.534149 6.114601 -4.706758 42 120 124 + 122 C -9.745157 4.269631 -3.191928 40 120 125 126 127 + 123 H -11.263017 4.131676 -4.781723 39 120 + 124 HO -9.713871 6.599029 -4.391676 43 121 + 125 H -9.116723 4.972749 -2.508566 41 122 + 126 H -9.168034 3.361328 -3.330127 41 122 + 127 H -10.522836 3.973872 -2.499829 41 122 + 128 N -11.233860 3.687218 -7.306137 7 116 129 132 + 129 CA -12.200193 3.653311 -8.374575 8 128 130 133 134 + 130 C -13.220650 4.788154 -8.169599 9 129 131 147 + 131 O -13.737841 5.372844 -9.165473 11 130 + 132 HN -11.460538 2.988105 -6.540266 10 128 + 133 H -11.637688 3.949136 -9.406377 12 129 + 134 C -12.914543 2.186268 -8.423705 19 129 135 138 139 + 135 C -12.050888 0.859767 -8.189045 21 134 136 137 140 + 136 C -12.754212 -0.443223 -8.481524 23 135 141 142 143 + 137 C -10.761720 0.854864 -8.962914 23 135 144 145 146 + 138 H -13.378342 2.203311 -9.441391 20 134 + 139 H -13.731396 2.273518 -7.697910 20 134 + 140 H -11.784384 0.837730 -7.097584 22 135 + 141 H -12.178199 -1.386252 -8.511713 24 136 + 142 H -13.030296 -0.361584 -9.541647 24 136 + 143 H -13.665537 -0.574300 -7.888432 24 136 + 144 H -10.907312 0.853311 -10.020395 24 137 + 145 H -10.166450 -0.087962 -8.625340 24 137 + 146 H -10.131655 1.808766 -8.717686 24 137 + 147 N -13.463568 5.196109 -6.936262 7 130 148 151 + 148 CA -14.321525 6.337206 -6.640073 33 147 149 152 153 + 149 C -13.602436 7.749411 -6.813046 9 148 150 161 + 150 O -14.285287 8.753093 -7.068264 11 149 + 151 HN -13.224563 4.686522 -6.108713 10 147 + 152 H -15.116925 6.447123 -7.471724 12 148 + 153 C -15.130805 6.126006 -5.300665 38 148 154 155 156 + 154 OH -14.245708 5.884444 -4.246742 42 153 157 + 155 C -16.085304 4.854769 -5.370470 40 153 158 159 160 + 156 H -15.668029 7.073411 -5.139360 39 153 + 157 HO -13.863528 6.745981 -4.031876 43 154 + 158 H -16.931480 4.985645 -6.114646 41 155 + 159 H -16.633409 4.776539 -4.392875 41 155 + 160 H -15.447009 3.996959 -5.527187 41 155 + 161 N -12.255780 7.804163 -6.773987 1 149 162 165 + 162 CA -11.475822 9.029360 -6.961862 2 161 163 166 167 + 163 C -10.482668 9.429993 -5.875126 3 162 164 168 + 164 O -9.615012 10.212498 -6.150085 5 163 + 165 HN -11.791631 6.946169 -6.476230 4 161 + 166 H -10.849439 8.869550 -7.825758 6 162 + 167 H -12.070294 9.912283 -7.089554 6 162 + 168 N -10.710240 8.937450 -4.551265 7 163 169 172 + 169 CA -9.795182 9.275190 -3.486218 8 168 170 173 174 + 170 C -8.432503 8.733444 -3.903900 9 169 171 190 + 171 O -8.256860 7.497941 -4.141932 11 170 + 172 HN -11.613017 8.458729 -4.378865 10 168 + 173 H -9.758201 10.415786 -3.586213 12 169 + 174 C -10.207682 8.847560 -2.068515 185 169 175 179 180 + 175 C -9.468868 9.640494 -0.969458 187 174 176 181 182 + 176 C -9.960726 11.106750 -0.880514 189 175 177 183 184 + 177 C -8.996147 11.882980 0.056845 191 176 178 185 186 + 178 N -9.422979 13.246330 0.389189 193 177 187 188 189 + 179 H -10.025076 7.711214 -1.993654 186 174 + 180 H -11.260829 8.969143 -1.909413 186 174 + 181 H -8.357381 9.561485 -1.037070 188 175 + 182 H -9.831062 9.156523 0.052119 188 175 + 183 H -10.951565 11.152527 -0.421834 190 176 + 184 H -10.025528 11.645570 -1.861235 190 176 + 185 H -7.996392 12.007902 -0.493686 192 177 + 186 H -8.903714 11.241749 1.019391 192 177 + 187 HN -9.372439 13.931515 -0.356496 194 178 + 188 HN -8.869279 13.642636 1.216690 194 178 + 189 HN -10.417962 13.346471 0.725918 194 178 + 190 N -7.417712 9.626751 -3.887457 7 170 191 194 + 191 CA -6.048686 9.319758 -4.265281 33 190 192 195 196 + 192 C -5.195256 9.655954 -3.012996 9 191 193 204 + 193 O -5.383682 10.790154 -2.469855 11 192 + 194 HN -7.536192 10.638944 -3.603417 10 190 + 195 H -5.899497 8.237555 -4.489940 12 191 + 196 C -5.632346 10.139153 -5.558621 38 191 197 198 199 + 197 OH -6.651850 9.845307 -6.610520 42 196 200 + 198 C -4.307909 9.733791 -6.252541 40 196 201 202 203 + 199 H -5.546957 11.240303 -5.391676 39 196 + 200 HO -7.479446 10.239776 -6.352124 43 197 + 201 H -4.057722 10.346459 -7.141293 41 198 + 202 H -4.216816 8.651918 -6.414903 41 198 + 203 H -3.513698 9.947681 -5.542599 41 198 + 204 N -4.487761 8.698281 -2.479508 7 192 205 208 + 205 CA -3.941682 8.719222 -1.101838 8 204 206 209 210 + 206 C -2.471661 8.338585 -1.186861 9 205 207 223 + 207 O -2.098577 7.337481 -1.795680 11 206 + 208 HN -4.371107 7.734334 -2.775858 10 204 + 209 H -3.985516 9.750968 -0.737465 12 205 + 210 C -4.697768 7.852820 -0.064484 25 205 211 212 214 + 211 C -4.708913 6.295035 -0.438982 29 210 213 215 216 + 212 C -6.123205 8.316839 0.212195 27 210 217 218 219 + 213 C -5.620903 5.382941 0.512646 31 211 220 221 222 + 214 H -4.057362 7.911400 0.860642 26 210 + 215 H -3.677285 5.838816 -0.381317 30 211 + 216 H -5.097879 6.136516 -1.456773 30 211 + 217 H -6.958332 8.061232 -0.486042 28 212 + 218 H -6.120750 9.492014 0.254246 28 212 + 219 H -6.463653 8.052122 1.235972 28 212 + 220 H -6.708420 5.577546 0.309314 32 213 + 221 H -5.353714 5.729677 1.560568 32 213 + 222 H -5.449967 4.323238 0.397743 32 213 + 223 N -1.597496 9.147378 -0.364603 7 206 224 227 + 224 CA -0.135695 9.298656 -0.268971 33 223 225 228 229 + 225 C 0.407838 8.259131 0.762984 9 224 226 237 + 226 O -0.125678 8.256398 1.864934 11 225 + 227 HN -2.061490 9.698188 0.341812 10 223 + 228 H 0.291486 9.062300 -1.222284 12 224 + 229 C 0.359683 10.712136 0.203065 38 224 230 231 232 + 230 OH -0.513535 11.802509 -0.157986 42 229 233 + 231 C 1.661404 11.100111 -0.496546 40 229 234 235 236 + 232 H 0.487415 10.613723 1.289529 39 229 + 233 HO -0.894682 12.193680 0.613553 43 230 + 234 H 1.924560 12.095482 -0.170163 41 231 + 235 H 1.527624 11.126022 -1.612055 41 231 + 236 H 2.524096 10.406872 -0.273554 41 231 + 237 N 1.458638 7.533911 0.367476 7 225 238 241 + 238 CA 2.250809 6.653110 1.155065 8 237 239 242 243 + 239 C 3.767103 6.967571 0.917085 9 238 240 256 + 240 O 4.150469 7.414883 -0.134304 11 239 + 241 HN 1.800100 7.626011 -0.603649 10 237 + 242 H 1.984132 6.848652 2.199761 12 238 + 243 C 1.985932 5.208560 0.673411 19 238 244 247 248 + 244 C 0.499001 4.775460 0.950638 21 243 245 246 249 + 245 C 0.302449 3.382258 0.307039 23 244 250 251 252 + 246 C 0.318833 4.590905 2.467625 23 244 253 254 255 + 247 H 2.620352 4.479840 1.153057 20 243 + 248 H 2.170192 5.140748 -0.421262 20 243 + 249 H -0.141837 5.460611 0.448133 22 244 + 250 H -0.765868 3.158508 0.337643 24 245 + 251 H 0.881511 2.586559 0.876485 24 245 + 252 H 0.635114 3.382961 -0.727832 24 245 + 253 H 0.991181 3.809378 2.860913 24 246 + 254 H -0.810422 4.305406 2.724253 24 246 + 255 H 0.495432 5.527245 3.085307 24 246 + 256 N 4.493868 6.668739 2.051013 7 239 257 260 + 257 CA 5.977452 6.826187 2.081574 8 256 258 261 262 + 258 C 6.574479 5.473810 2.542943 9 257 259 271 + 259 O 7.539223 5.437653 3.331859 11 258 + 260 HN 4.101906 6.335458 2.916399 10 256 + 261 H 6.354091 6.853748 1.027532 12 257 + 262 C 6.470006 8.005228 2.962480 156 257 263 267 268 + 263 C 6.523156 9.385148 2.265263 158 262 264 269 270 + 264 C 6.660389 10.531119 3.176475 160 263 265 266 + 265 O 7.818717 10.946737 3.494784 161 264 + 266 O 5.641727 11.057335 3.676704 161 264 + 267 H 7.426538 7.872313 3.417016 157 262 + 268 H 5.818378 7.862045 3.841666 157 262 + 269 H 5.562369 9.490953 1.596644 159 263 + 270 H 7.296811 9.382149 1.478494 159 263 + 271 N 6.080956 4.317668 2.172588 7 258 272 275 + 272 CA 6.395184 2.914756 2.360428 8 271 273 276 277 + 273 C 7.756330 2.626277 1.796235 9 272 274 287 + 274 O 8.336336 3.369371 0.946953 11 273 + 275 HN 5.286582 4.431259 1.580017 10 271 + 276 H 6.544551 2.775770 3.450173 12 272 + 277 C 5.254270 2.029334 1.828047 15 272 278 279 280 + 278 C 3.855516 2.115298 2.663831 17 277 281 282 283 + 279 C 4.878513 2.275077 0.297641 17 277 284 285 286 + 280 H 5.659978 0.937168 1.997214 16 277 + 281 H 3.988977 1.632132 3.721066 18 278 + 282 H 3.154094 1.488836 2.202125 18 278 + 283 H 3.518024 3.208135 2.707458 18 278 + 284 H 4.391723 3.244259 0.119355 18 279 + 285 H 4.197460 1.515591 -0.214541 18 279 + 286 H 5.820024 2.281294 -0.232189 18 279 + 287 N 8.439412 1.532076 2.306730 7 273 288 291 + 288 CA 9.766718 1.104522 1.810124 8 287 289 292 293 + 289 C 9.609640 -0.146333 0.921245 9 288 290 302 + 290 O 8.595667 -0.823014 1.060066 11 289 + 291 HN 7.906057 0.817610 2.769235 10 287 + 292 H 10.402589 1.878772 1.340853 12 288 + 293 C 10.623245 0.647963 3.024596 156 288 294 298 299 + 294 C 11.099332 1.681203 4.040791 158 293 295 300 301 + 295 C 12.471923 2.276164 3.591284 160 294 296 297 + 296 O 13.467460 1.635754 4.022756 161 295 + 297 O 12.447093 3.241865 2.732975 161 295 + 298 H 11.464087 0.045385 2.632771 157 293 + 299 H 10.035308 -0.165388 3.606999 157 293 + 300 H 11.283249 1.117646 5.042705 159 294 + 301 H 10.341030 2.493195 4.310498 159 294 + 302 N 10.649425 -0.442448 0.039711 53 289 303 309 + 303 CA 10.721650 -1.691625 -0.719097 54 302 304 306 307 + 304 C 10.688929 -3.019270 0.171469 55 303 305 316 + 305 O 10.136780 -4.017164 -0.258017 56 304 + 306 H 9.824725 -1.703322 -1.331408 57 303 + 307 C 12.047830 -1.730137 -1.583772 58 303 308 310 311 + 308 C 12.438841 -0.254934 -1.430560 60 307 309 312 313 + 309 C 11.880473 0.342410 -0.130781 62 302 308 314 315 + 310 H 11.910217 -2.011767 -2.680814 59 307 + 311 H 12.740874 -2.453727 -1.101295 59 307 + 312 H 12.084519 0.391154 -2.320456 61 308 + 313 H 13.550172 -0.165266 -1.345695 61 308 + 314 H 11.730541 1.403440 -0.268593 63 309 + 315 H 12.568702 0.262680 0.684216 63 309 + 316 N 11.185418 -2.821488 1.401909 7 304 317 320 + 317 CA 11.478487 -3.819995 2.417066 33 316 318 321 322 + 318 C 10.240507 -4.133695 3.340195 9 317 319 327 + 319 O 10.437807 -4.944657 4.272068 11 318 + 320 HN 11.675553 -1.939666 1.629182 10 316 + 321 H 11.715305 -4.763029 1.892686 12 317 + 322 C 12.726302 -3.441835 3.258589 34 317 323 324 325 + 323 OH 12.588509 -2.169159 3.871288 36 322 326 + 324 H 13.594515 -3.465914 2.619460 35 322 + 325 H 12.919669 -4.225010 4.041833 35 322 + 326 HO 11.928461 -2.056942 4.572136 37 323 + 327 N 8.989610 -3.538327 3.147788 7 318 328 331 + 328 CA 7.780090 -3.809839 3.903153 8 327 329 332 333 + 329 C 6.830692 -4.723128 3.182411 9 328 330 339 + 330 O 6.843975 -4.931536 1.971249 11 329 + 331 HN 8.790490 -2.959432 2.207143 10 327 + 332 H 8.112743 -4.402734 4.754275 12 328 + 333 C 7.007696 -2.493713 4.325713 140 328 334 337 338 + 334 C 7.757815 -1.793205 5.421557 142 333 335 336 + 335 O 8.301432 -0.683792 5.213313 143 334 + 336 O 8.105449 -2.430264 6.467845 143 334 + 337 H 6.015719 -2.736995 4.787540 141 333 + 338 H 6.870322 -1.705199 3.554568 141 333 + 339 N 5.911537 -5.420074 3.889645 7 329 340 343 + 340 CA 4.985368 -6.339027 3.207488 33 339 341 344 345 + 341 C 3.791981 -5.460118 2.675447 9 340 342 353 + 342 O 3.602436 -4.262217 3.058351 11 341 + 343 HN 5.945002 -5.355465 4.936544 10 339 + 344 H 5.522096 -6.871961 2.401608 12 340 + 345 C 4.403843 -7.437211 4.151447 38 340 346 347 348 + 346 OH 3.984983 -6.837474 5.417872 42 345 349 + 347 C 5.484751 -8.435266 4.460478 40 345 350 351 352 + 348 H 3.543374 -7.871125 3.610585 39 345 + 349 HO 3.626750 -7.635311 5.866975 43 346 + 350 H 5.852794 -8.923165 3.576288 41 347 + 351 H 5.092476 -9.235700 5.230406 41 347 + 352 H 6.347457 -8.009387 5.033245 41 347 + 353 N 3.001520 -6.091562 1.873663 7 341 354 357 + 354 CA 1.770212 -5.563203 1.356920 8 353 355 358 359 + 355 C 0.721356 -5.331197 2.570590 9 354 356 372 + 356 O -0.022158 -4.354859 2.639919 11 355 + 357 HN 3.312873 -6.951353 1.400664 10 353 + 358 H 2.050592 -4.577254 0.922928 12 354 + 359 C 1.071972 -6.339450 0.158527 25 354 360 361 363 + 360 C 1.737761 -5.960287 -1.242592 29 359 362 364 365 + 361 C -0.457848 -6.189077 0.133627 27 359 366 367 368 + 362 C 3.239275 -5.961276 -1.280042 31 360 369 370 371 + 363 H 1.324741 -7.458613 0.269568 26 359 + 364 H 1.479259 -4.859796 -1.271486 30 360 + 365 H 1.361220 -6.531125 -2.132946 30 360 + 366 H -0.903041 -6.854230 -0.657366 28 361 + 367 H -0.782418 -5.132849 -0.071473 28 361 + 368 H -0.922422 -6.573767 1.109124 28 361 + 369 H 3.570026 -6.965706 -1.066579 32 362 + 370 H 3.783014 -5.330759 -0.595789 32 362 + 371 H 3.656696 -5.782972 -2.272787 32 362 + 372 N 0.712989 -6.304521 3.584311 7 355 373 376 + 373 CA 0.052790 -6.261661 4.839148 8 372 374 377 378 + 374 C 0.191347 -4.895606 5.488007 9 373 375 387 + 375 O -0.836031 -4.209177 5.761481 11 374 + 376 HN 1.234822 -7.176952 3.358561 10 372 + 377 H -1.022887 -6.329021 4.691721 12 373 + 378 C 0.463881 -7.420468 5.813551 156 373 379 383 384 + 379 C -0.181732 -7.570702 7.165576 158 378 380 385 386 + 380 C 0.007120 -6.414258 8.102713 160 379 381 382 + 381 O -0.893307 -5.557057 8.345423 161 380 + 382 O 1.071916 -6.451342 8.739901 161 380 + 383 H 1.565739 -7.379644 5.945185 157 378 + 384 H 0.280894 -8.335875 5.233490 157 378 + 385 H 0.223173 -8.515314 7.648734 159 379 + 386 H -1.278836 -7.754581 6.974807 159 379 + 387 N 1.506487 -4.494779 5.655260 7 374 388 391 + 388 CA 2.024384 -3.272083 6.150972 8 387 389 392 393 + 389 C 1.585880 -2.044887 5.407014 9 388 390 401 + 390 O 1.072089 -1.054656 5.937784 11 389 + 391 HN 2.247022 -5.169015 5.381363 10 387 + 392 H 1.726295 -3.077017 7.202284 12 388 + 393 C 3.519486 -3.297907 6.249706 150 388 394 397 398 + 394 C 4.110165 -2.209620 7.106417 152 393 395 396 + 395 O 4.558866 -1.206675 6.574355 153 394 + 396 N 3.975447 -2.353795 8.429417 154 394 399 400 + 397 H 3.926527 -3.312701 5.199577 151 393 + 398 H 3.906987 -4.290859 6.729019 151 393 + 399 HN 3.351621 -3.100412 8.835262 155 396 + 400 HN 4.250233 -1.572327 9.095945 155 396 + 401 N 1.646215 -2.106555 3.995169 7 389 402 405 + 402 CA 0.960547 -1.056203 3.144271 8 401 403 406 407 + 403 C -0.585323 -0.906494 3.471384 9 402 404 417 + 404 O -1.001272 0.221409 3.639638 11 403 + 405 HN 2.076586 -2.917444 3.633085 10 401 + 406 H 1.398083 -0.037330 3.348893 12 402 + 407 C 1.148406 -1.421290 1.565953 15 402 408 409 410 + 408 C 0.469253 -0.291141 0.677094 17 407 411 412 413 + 409 C 2.652804 -1.432319 1.256255 17 407 414 415 416 + 410 H 0.776571 -2.470203 1.403081 16 407 + 411 H -0.604778 -0.059927 0.825468 18 408 + 412 H 0.696071 -0.403531 -0.364402 18 408 + 413 H 0.904174 0.691668 0.985463 18 408 + 414 H 2.642691 -1.597766 0.131660 18 409 + 415 H 3.137894 -2.381059 1.586216 18 409 + 416 H 3.298051 -0.632131 1.598249 18 409 + 417 N -1.305966 -1.988607 3.652565 7 403 418 421 + 418 CA -2.689415 -1.960736 4.065894 8 417 419 422 423 + 419 C -2.947986 -1.384388 5.464246 9 418 420 439 + 420 O -3.956927 -0.687209 5.701440 11 419 + 421 HN -0.971106 -2.849328 3.302467 10 417 + 422 H -3.296900 -1.262385 3.382761 12 418 + 423 C -3.427836 -3.412377 3.961933 185 418 424 428 429 + 424 C -3.574171 -3.928612 2.505721 187 423 425 430 431 + 425 C -3.982306 -5.479470 2.370643 189 424 426 432 433 + 426 C -4.137753 -5.916145 0.907307 191 425 427 434 435 + 427 N -4.842456 -7.207476 0.671588 193 426 436 437 438 + 428 H -4.389394 -3.425752 4.550163 186 423 + 429 H -2.806920 -4.163717 4.552623 186 423 + 430 H -2.578225 -3.744348 2.022778 188 424 + 431 H -4.131610 -3.317335 1.794895 188 424 + 432 H -4.944670 -5.685367 2.884988 190 425 + 433 H -3.219699 -6.072549 2.922384 190 425 + 434 H -3.220948 -5.866340 0.240386 192 426 + 435 H -4.886137 -5.224022 0.371600 192 426 + 436 HN -4.398637 -8.010724 1.108282 194 427 + 437 HN -4.689919 -7.536305 -0.283243 194 427 + 438 HN -5.789366 -7.298894 0.961468 194 427 + 439 N -1.966539 -1.653932 6.352370 7 419 440 443 + 440 CA -1.877059 -1.184384 7.700740 8 439 441 444 445 + 441 C -1.810243 0.352689 7.772527 9 440 442 449 + 442 O -2.478130 1.012858 8.630055 11 441 + 443 HN -1.296883 -2.342673 6.065841 10 439 + 444 H -2.903503 -1.425619 8.306499 12 440 + 445 C -0.719870 -1.906634 8.460693 13 440 446 447 448 + 446 H -0.392867 -1.394748 9.399750 14 445 + 447 H 0.201561 -1.700787 7.931161 14 445 + 448 H -0.824494 -3.016135 8.415257 14 445 + 449 N -1.014819 0.884949 6.873831 7 441 450 453 + 450 CA -0.928004 2.359933 6.752150 8 449 451 454 455 + 451 C -2.242871 3.020975 6.141860 9 450 452 471 + 452 O -2.667293 4.165871 6.497798 11 451 + 453 HN -0.255487 0.266534 6.475305 10 449 + 454 H -0.709751 2.767594 7.790539 12 450 + 455 C 0.185451 2.818592 5.731872 185 450 456 460 461 + 456 C 1.718082 2.368933 6.157097 187 455 457 462 463 + 457 C 1.976397 2.630036 7.634372 189 456 458 464 465 + 458 C 3.272626 1.811866 8.042755 191 457 459 466 467 + 459 N 3.783277 2.119562 9.341763 193 458 468 469 470 + 460 H 0.173809 4.017727 5.824418 186 455 + 461 H -0.110843 2.644975 4.655738 186 455 + 462 H 2.436177 2.906087 5.459782 188 456 + 463 H 1.767963 1.228903 6.013437 188 456 + 464 H 1.214734 2.413689 8.372810 190 457 + 465 H 2.023085 3.725792 7.759055 190 457 + 466 H 4.113891 1.884123 7.336520 192 458 + 467 H 2.915132 0.727469 8.065927 192 458 + 468 HN 3.879659 1.332383 9.938486 194 459 + 469 HN 3.292027 2.768104 9.893226 194 459 + 470 HN 4.657654 2.620898 9.415395 194 459 + 471 N -2.951323 2.325118 5.282730 7 451 472 475 + 472 CA -4.325905 2.722744 4.841568 8 471 473 476 477 + 473 C -5.448579 2.576087 5.910067 9 472 474 490 + 474 O -6.209518 3.521045 6.095847 11 473 + 475 HN -2.521898 1.551084 4.791650 10 471 + 476 H -4.313051 3.829830 4.708638 12 472 + 477 C -4.631289 2.056947 3.491556 25 472 478 479 481 + 478 C -3.597982 2.356462 2.341899 29 477 480 482 483 + 479 C -6.057287 2.415036 2.978562 27 477 484 485 486 + 480 C -3.795503 1.412901 1.156511 31 478 487 488 489 + 481 H -4.671054 0.937191 3.752299 26 477 + 482 H -2.607674 2.121882 2.680974 30 478 + 483 H -3.588639 3.467984 2.067654 30 478 + 484 H -6.778277 2.127584 3.784506 28 479 + 485 H -6.408690 1.672558 2.286363 28 479 + 486 H -6.257305 3.445522 2.543283 28 479 + 487 H -2.827681 1.370598 0.452926 32 480 + 488 H -4.701905 1.709692 0.600596 32 480 + 489 H -3.968868 0.353877 1.535108 32 480 + 490 N -5.427736 1.517434 6.772139 7 473 491 494 + 491 CA -6.281638 1.417159 7.917235 8 490 492 495 496 + 492 C -6.135061 2.619316 8.825463 9 491 493 507 + 493 O -7.083993 3.050483 9.468967 11 492 + 494 HN -4.778187 0.710522 6.592937 10 490 + 495 H -7.347518 1.392997 7.523591 12 491 + 496 C -5.911289 0.089334 8.730160 170 491 497 501 502 + 497 C -6.704804 -0.165892 10.024245 172 496 498 503 504 + 498 C -8.207420 0.060746 9.966819 174 497 499 500 + 499 O -8.766731 0.511631 10.987813 175 498 + 500 N -8.851167 -0.577098 8.977765 176 498 505 506 + 501 H -4.871800 0.035639 8.932959 171 496 + 502 H -6.099650 -0.797867 8.002499 171 496 + 503 H -6.379603 0.602172 10.795373 173 497 + 504 H -6.514059 -1.228415 10.339368 173 497 + 505 HN -8.316985 -1.014678 8.258816 177 500 + 506 HN -9.833090 -0.545963 8.919578 177 500 + 507 N -4.878643 3.139322 9.062914 7 492 508 511 + 508 CA -4.649566 4.328949 9.987955 8 507 509 512 513 + 509 C -4.957775 5.668926 9.413617 9 508 510 519 + 510 O -5.630236 6.445624 10.106188 11 509 + 511 HN -4.081549 2.846329 8.507102 10 507 + 512 H -5.406537 4.281488 10.784832 12 508 + 513 C -3.243945 4.227889 10.546816 140 508 514 517 518 + 514 C -3.087728 5.171882 11.728346 142 513 515 516 + 515 O -4.053576 5.190045 12.600221 143 514 + 516 O -2.058101 5.835943 11.978474 143 514 + 517 H -2.562382 4.521403 9.724738 141 513 + 518 H -2.932032 3.215635 10.964683 141 513 + 519 N -4.878039 5.785317 8.031390 7 509 520 523 + 520 CA -5.310084 7.089332 7.406389 8 519 521 524 525 + 521 C -6.749125 7.172087 6.971101 9 520 522 541 + 522 O -7.405628 8.229614 7.089684 11 521 + 523 HN -4.283642 5.091117 7.531729 10 519 + 524 H -5.274077 7.841191 8.198368 12 520 + 525 C -4.287673 7.649544 6.440392 185 520 526 530 531 + 526 C -4.264316 6.824230 5.084233 187 525 527 532 533 + 527 C -3.348184 7.282872 3.940214 189 526 528 534 535 + 528 C -1.862959 6.984827 4.246876 191 527 529 536 537 + 529 N -1.232990 7.951755 5.175746 193 528 538 539 540 + 530 H -3.353989 7.682751 6.978380 186 525 + 531 H -4.577117 8.665353 6.188031 186 525 + 532 H -5.271336 7.010431 4.645228 188 526 + 533 H -4.183939 5.756196 5.214904 188 526 + 534 H -3.478219 8.414723 3.726542 190 527 + 535 H -3.567163 6.665420 3.125679 190 527 + 536 H -1.380469 7.033451 3.200397 192 528 + 537 H -1.658625 5.960828 4.579387 192 528 + 538 HN -1.681026 8.865239 5.169898 194 529 + 539 HN -0.322832 8.170574 4.811931 194 529 + 540 HN -1.120976 7.690090 6.115363 194 529 + 541 N -7.260673 6.129896 6.365283 7 521 542 545 + 542 CA -8.574938 6.119982 5.731267 8 541 543 546 547 + 543 C -9.544300 5.242356 6.500946 9 542 544 556 + 544 O -10.776630 5.341657 6.228564 11 543 + 545 HN -6.694313 5.297054 6.084394 10 541 + 546 H -8.965369 7.148290 5.836761 12 542 + 547 C -8.593435 5.700600 4.232465 156 542 548 552 553 + 548 C -8.142917 6.797216 3.313691 158 547 549 554 555 + 549 C -8.922098 8.128550 3.290754 160 548 550 551 + 550 O -10.019708 8.282415 2.683597 161 549 + 551 O -8.418377 9.080422 3.962396 161 549 + 552 H -9.637470 5.370747 3.983240 157 547 + 553 H -7.841735 4.791994 4.106244 157 547 + 554 H -7.988334 6.410373 2.240226 159 548 + 555 H -7.108545 7.056748 3.606925 159 548 + 556 N -9.109752 4.287946 7.340476 1 543 557 560 + 557 CA -10.009860 3.416611 8.055823 2 556 558 561 562 + 558 C -10.705939 2.327979 7.248022 3 557 559 563 + 559 O -11.556202 1.623209 7.719085 5 558 + 560 HN -8.134437 4.133993 7.462110 4 556 + 561 H -9.403268 2.909131 8.828371 6 557 + 562 H -10.766691 4.008828 8.630570 6 557 + 563 N -10.238426 2.084832 5.988242 7 558 564 567 + 564 CA -10.830327 1.014314 5.135787 8 563 565 568 569 + 565 C -10.123635 -0.408365 5.490888 9 564 566 582 + 566 O -8.886974 -0.473105 5.573450 11 565 + 567 HN -9.463779 2.473999 5.471519 10 563 + 568 H -11.972825 0.862184 5.405029 12 564 + 569 C -10.573783 1.408499 3.605155 25 564 570 571 573 + 570 C -11.473874 2.659840 3.274246 29 569 572 574 575 + 571 C -10.768674 0.116838 2.675834 27 569 576 577 578 + 572 C -11.386046 3.100490 1.827956 31 570 579 580 581 + 573 H -9.497664 1.719665 3.575726 26 569 + 574 H -11.189235 3.505368 3.971634 30 570 + 575 H -12.466031 2.387035 3.608591 30 570 + 576 H -10.418619 0.285197 1.650312 28 571 + 577 H -11.889425 -0.154704 2.658339 28 571 + 578 H -10.253412 -0.844191 2.935472 28 571 + 579 H -10.489631 3.687189 1.608836 32 572 + 580 H -12.252949 3.808896 1.730836 32 572 + 581 H -11.600834 2.256313 1.164934 32 572 + 582 N -10.904182 -1.495291 5.769914 53 565 583 589 + 583 CA -10.294825 -2.685192 6.266115 54 582 584 586 587 + 584 C -9.362686 -3.411747 5.150144 55 583 585 596 + 585 O -9.822907 -3.806655 4.048145 56 584 + 586 H -9.678597 -2.483780 7.200705 57 583 + 587 C -11.433893 -3.623279 6.740457 58 583 588 590 591 + 588 C -12.623002 -3.096904 5.800687 60 587 589 592 593 + 589 C -12.355474 -1.596314 5.926055 62 582 588 594 595 + 590 H -11.632975 -3.481644 7.836795 59 587 + 591 H -11.185183 -4.717775 6.760900 59 587 + 592 H -13.676441 -3.284634 6.130235 61 588 + 593 H -12.571296 -3.294434 4.749284 61 588 + 594 H -12.712668 -1.093954 6.983468 63 589 + 595 H -12.878080 -1.082331 5.087665 63 589 + 596 N -8.141305 -3.913338 5.553940 53 584 597 603 + 597 CA -7.265296 -4.892156 4.877616 54 596 598 600 601 + 598 C -7.954629 -6.074235 4.106746 55 597 599 610 + 599 O -7.526189 -6.449816 3.017058 56 598 + 600 H -6.579043 -4.462262 4.120819 57 597 + 601 C -6.340090 -5.386881 5.987491 58 597 602 604 605 + 602 C -6.098980 -4.115508 6.793069 60 601 603 606 607 + 603 C -7.478029 -3.499220 6.819358 62 596 602 608 609 + 604 H -5.439953 -5.907262 5.648183 59 601 + 605 H -6.857707 -6.166813 6.603499 59 601 + 606 H -5.359728 -3.456071 6.338156 61 602 + 607 H -5.774381 -4.378426 7.875984 61 602 + 608 H -7.367742 -2.409829 6.921891 63 603 + 609 H -8.055072 -3.868224 7.656931 63 603 + 610 N -9.008919 -6.608446 4.793434 7 598 611 614 + 611 CA -9.678181 -7.733135 4.285369 8 610 612 615 616 + 612 C -10.514900 -7.453854 3.062726 9 611 613 622 + 613 O -10.598980 -8.267352 2.099054 11 612 + 614 HN -9.372380 -6.226786 5.718134 10 610 + 615 H -8.952673 -8.430078 3.800831 12 611 + 616 C -10.385978 -8.504460 5.406790 140 611 617 620 621 + 617 C -11.095963 -9.718862 4.959627 142 616 618 619 + 618 O -12.323382 -9.860403 5.304109 143 617 + 619 O -10.342738 -10.617376 4.418998 143 617 + 620 H -11.151852 -7.927877 5.826167 141 616 + 621 H -9.623560 -8.740853 6.193107 141 616 + 622 N -11.049078 -6.202245 2.940419 7 612 623 626 + 623 CA -11.642018 -5.709443 1.705877 8 622 624 627 628 + 624 C -10.614336 -5.092838 0.713167 9 623 625 639 + 625 O -10.927213 -4.951138 -0.459225 11 624 + 626 HN -11.081256 -5.587042 3.696816 10 622 + 627 H -11.984075 -6.605539 1.087897 12 623 + 628 C -12.768231 -4.705104 1.983069 170 623 629 633 634 + 629 C -13.883829 -5.316250 2.907105 172 628 630 635 636 + 630 C -15.114338 -4.418666 2.924881 174 629 631 632 + 631 O -15.405304 -3.917271 4.026449 175 630 + 632 N -15.906827 -4.358107 1.868346 176 630 637 638 + 633 H -13.285557 -4.431812 1.024843 171 628 + 634 H -12.425058 -3.757312 2.498081 171 628 + 635 H -13.493993 -5.422715 3.976146 173 629 + 636 H -14.172955 -6.317959 2.590855 173 629 + 637 HN -15.643280 -4.761085 0.943045 177 632 + 638 HN -16.887617 -4.110344 2.002905 177 632 + 639 N -9.403516 -4.718671 1.187009 7 624 640 643 + 640 CA -8.418526 -4.190723 0.263736 8 639 641 644 645 + 641 C -7.842430 -5.239112 -0.660532 9 640 642 656 + 642 O -7.328931 -6.262671 -0.141830 11 641 + 643 HN -9.039521 -4.862514 2.100989 10 639 + 644 H -8.913388 -3.436668 -0.331077 12 640 + 645 C -7.143827 -3.503558 1.041637 170 640 646 650 651 + 646 C -7.586437 -2.244888 1.828880 172 645 647 652 653 + 647 C -6.397386 -1.503568 2.513414 174 646 648 649 + 648 O -5.279630 -1.340947 1.984414 175 647 + 649 N -6.649301 -1.020214 3.747788 176 647 654 655 + 650 H -6.392988 -3.161834 0.246377 171 645 + 651 H -6.600747 -4.159050 1.729753 171 645 + 652 H -8.388106 -2.412938 2.663083 173 646 + 653 H -8.063908 -1.554062 1.129126 173 646 + 654 HN -7.599327 -0.974932 4.121687 177 649 + 655 HN -5.824088 -0.762663 4.379842 177 649 + 656 N -7.975739 -5.085940 -2.051099 7 641 657 660 + 657 CA -7.316226 -5.859411 -3.099220 8 656 658 661 662 + 658 C -6.535954 -4.884159 -3.940503 9 657 659 680 + 659 O -7.016650 -4.323287 -4.885061 11 658 + 660 HN -8.649330 -4.421740 -2.442279 10 656 + 661 H -6.552638 -6.577875 -2.549459 12 657 + 662 C -8.293193 -6.657174 -4.000956 205 657 663 669 670 + 663 C -8.951016 -7.920548 -3.205693 207 662 664 671 672 + 664 C -8.120004 -9.231611 -2.981077 209 663 665 673 674 + 665 N -7.224446 -9.317181 -1.844858 211 664 666 675 + 666 C -6.456272 -10.352566 -1.540149 213 665 667 668 + 667 N -6.261777 -11.358001 -2.422146 214 666 676 677 + 668 N -6.102837 -10.524228 -0.288739 214 666 678 679 + 669 H -7.757336 -7.047341 -4.904160 206 662 + 670 H -9.163272 -5.963583 -4.290787 206 662 + 671 H -9.924984 -8.240285 -3.732011 208 663 + 672 H -9.185465 -7.539611 -2.167170 208 663 + 673 H -7.474087 -9.426829 -3.909433 210 664 + 674 H -8.804222 -10.092199 -2.813314 210 664 + 675 HN -7.241497 -8.530605 -1.089185 212 665 + 676 HN -6.629122 -11.380337 -3.383889 215 667 + 677 HN -5.815388 -12.216685 -2.108949 215 667 + 678 HN -6.430516 -9.899279 0.447997 215 668 + 679 HN -5.622476 -11.346782 -0.024111 215 668 + 680 N -5.292942 -4.653337 -3.548836 7 658 681 684 + 681 CA -4.364875 -3.733621 -4.272520 8 680 682 685 686 + 682 C -3.884056 -4.434009 -5.580010 9 681 683 699 + 683 O -3.533279 -5.624908 -5.562725 11 682 + 684 HN -4.823372 -5.284331 -2.925755 10 680 + 685 H -4.946353 -2.808529 -4.509708 12 681 + 686 C -3.111739 -3.306714 -3.368632 19 681 687 690 691 + 687 C -3.512923 -2.415189 -2.103271 21 686 688 689 692 + 688 C -2.187524 -2.216424 -1.223893 23 687 693 694 695 + 689 C -3.958754 -1.022674 -2.555738 23 687 696 697 698 + 690 H -2.365328 -2.709721 -3.991308 20 686 + 691 H -2.556390 -4.179643 -2.968211 20 686 + 692 H -4.305604 -2.923554 -1.464240 22 687 + 693 H -2.062550 -3.144793 -0.620117 24 688 + 694 H -2.115031 -1.291482 -0.497561 24 688 + 695 H -1.342308 -2.211899 -1.862143 24 688 + 696 H -3.107951 -0.478453 -3.033604 24 689 + 697 H -4.161562 -0.403495 -1.628661 24 689 + 698 H -4.885892 -1.120725 -3.194404 24 689 + 699 N -3.856496 -3.700788 -6.722801 7 682 700 703 + 700 CA -3.452842 -4.182763 -8.089520 8 699 701 704 705 + 701 C -2.174020 -3.372729 -8.520048 9 700 702 718 + 702 O -2.088562 -2.114569 -8.327579 11 701 + 703 HN -3.898301 -2.618583 -6.734908 10 699 + 704 H -3.183017 -5.236597 -7.998616 12 700 + 705 C -4.717190 -3.967990 -8.947270 25 700 706 707 709 + 706 C -5.895436 -4.854833 -8.519342 29 705 708 710 711 + 707 C -4.331848 -4.232926 -10.428080 27 705 712 713 714 + 708 C -5.797633 -6.318004 -8.660393 31 706 715 716 717 + 709 H -4.967766 -2.891891 -8.863808 26 705 + 710 H -6.807800 -4.540991 -9.113471 30 706 + 711 H -6.224024 -4.682991 -7.474756 30 706 + 712 H -5.263890 -4.453041 -11.073519 28 707 + 713 H -3.637199 -5.120375 -10.524428 28 707 + 714 H -3.762608 -3.358380 -10.861528 28 707 + 715 H -4.807288 -6.678730 -8.216144 32 708 + 716 H -5.855482 -6.587729 -9.747066 32 708 + 717 H -6.665159 -6.845883 -8.176671 32 708 + 718 N -1.222564 -4.057751 -9.205087 7 701 719 722 + 719 CA -0.136624 -3.415950 -9.921138 8 718 720 723 724 + 720 C 0.070256 -3.976880 -11.394080 9 719 721 738 + 721 O 0.610536 -5.076439 -11.582664 11 720 + 722 HN -1.285072 -5.056820 -9.232195 10 718 + 723 H -0.492377 -2.326993 -10.196345 12 719 + 724 C 1.325233 -3.451838 -9.292553 64 719 725 731 732 + 725 C 2.252979 -2.485580 -9.980048 66 724 726 727 + 726 C 1.821424 -1.150642 -9.963953 67 725 728 733 + 727 C 3.553048 -2.772749 -10.524243 67 725 729 734 + 728 C 2.627188 -0.136222 -10.473998 69 726 730 735 + 729 C 4.271695 -1.747890 -11.019280 69 727 730 736 + 730 C 3.875296 -0.391840 -11.048201 71 728 729 737 + 731 H 1.721374 -4.514315 -9.302918 65 724 + 732 H 1.363608 -3.152679 -8.161531 65 724 + 733 H 0.900203 -0.869990 -9.442890 68 726 + 734 H 4.058655 -3.780788 -10.525233 68 727 + 735 H 2.406689 0.963664 -10.402987 70 728 + 736 H 5.227337 -2.093738 -11.483853 70 729 + 737 H 4.613135 0.382875 -11.414402 72 730 + 738 N -0.469213 -3.209862 -12.373989 7 720 739 742 + 739 CA -0.546701 -3.542255 -13.816781 8 738 740 743 744 + 740 C -1.166423 -4.938647 -14.104553 9 739 741 748 + 741 O -0.706356 -5.741630 -14.896149 11 740 + 742 HN -0.983659 -2.328002 -12.034153 10 738 + 743 H -1.328286 -2.810564 -14.197792 12 739 + 744 C 0.847710 -3.453814 -14.522754 13 739 745 746 747 + 745 H 1.557524 -2.617362 -14.253614 14 744 + 746 H 0.737328 -3.373371 -15.641978 14 744 + 747 H 1.440476 -4.334496 -14.238884 14 744 + 748 N -2.318816 -5.128826 -13.446057 1 740 749 752 + 749 CA -3.143886 -6.311856 -13.378529 2 748 750 753 754 + 750 C -2.861305 -7.249269 -12.148953 3 749 751 755 + 751 O -3.693124 -8.018797 -11.770725 5 750 + 752 HN -2.759876 -4.364139 -12.830293 4 748 + 753 H -4.238045 -6.105454 -13.271863 6 749 + 754 H -3.058170 -6.943948 -14.307195 6 749 + 755 N -1.585886 -7.303614 -11.606121 7 750 756 759 + 756 CA -1.141926 -8.330961 -10.575659 8 755 757 760 761 + 757 C -1.714720 -8.146916 -9.185538 9 756 758 777 + 758 O -1.663641 -7.016934 -8.671236 11 757 + 759 HN -0.991604 -6.486688 -11.627949 10 755 + 760 H -1.432507 -9.342075 -10.930403 12 756 + 761 C 0.441949 -8.242663 -10.513047 185 756 762 766 767 + 762 C 1.115895 -8.804397 -11.798957 187 761 763 768 769 + 763 C 2.659392 -8.559556 -11.862927 189 762 764 770 771 + 764 C 3.525297 -9.477008 -11.044076 191 763 765 772 773 + 765 N 4.928913 -9.126450 -11.049928 193 764 774 775 776 + 766 H 0.930008 -8.793558 -9.704840 186 761 + 767 H 0.820281 -7.154573 -10.383627 186 761 + 768 H 0.726808 -8.346899 -12.740661 188 762 + 769 H 0.816642 -9.905594 -11.898832 188 762 + 770 H 2.766554 -7.492314 -11.630235 190 763 + 771 H 2.990272 -8.709413 -12.938787 190 763 + 772 H 3.480243 -10.547229 -11.281436 192 764 + 773 H 3.142144 -9.394311 -9.993141 192 764 + 774 HN 5.380243 -9.145878 -11.941964 194 765 + 775 HN 5.445854 -9.749951 -10.436478 194 765 + 776 HN 5.117208 -8.202842 -10.744769 194 765 + 777 N -2.261410 -9.249088 -8.588259 7 757 778 781 + 778 CA -2.615396 -9.233499 -7.225533 8 777 779 782 783 + 779 C -1.335567 -8.948793 -6.438233 9 778 780 794 + 780 O -0.279868 -9.480653 -6.690356 11 779 + 781 HN -2.255352 -10.169786 -9.074177 10 777 + 782 H -3.334713 -8.420685 -7.023961 12 778 + 783 C -3.251131 -10.563774 -6.767452 170 778 784 788 789 + 784 C -4.535149 -10.474262 -6.008036 172 783 785 790 791 + 785 C -4.398618 -9.939824 -4.513090 174 784 786 787 + 786 O -5.077126 -8.969050 -4.171499 175 785 + 787 N -3.545204 -10.582628 -3.678241 176 785 792 793 + 788 H -2.536808 -11.208918 -6.196239 171 783 + 789 H -3.428126 -11.121298 -7.678818 171 783 + 790 H -4.970296 -11.490264 -5.897297 173 784 + 791 H -5.221487 -9.801148 -6.555491 173 784 + 792 HN -3.257694 -11.568395 -3.807768 177 787 + 793 HN -3.345020 -10.122941 -2.746863 177 787 + 794 N -1.450039 -8.014788 -5.496898 7 779 795 798 + 795 CA -0.421843 -7.645217 -4.599782 8 794 796 799 800 + 796 C -0.664467 -8.314648 -3.266854 9 795 797 813 + 797 O -1.615751 -8.129338 -2.521866 11 796 + 798 HN -2.373522 -7.541372 -5.361698 10 794 + 799 H 0.525104 -7.914594 -5.012102 12 795 + 800 C -0.361457 -6.082978 -4.502645 19 795 801 804 805 + 801 C 0.013954 -5.455430 -5.851982 21 800 802 803 806 + 802 C 0.049019 -3.957376 -5.617040 23 801 807 808 809 + 803 C 1.428022 -5.979157 -6.227374 23 801 810 811 812 + 804 H 0.435555 -5.929917 -3.703749 20 800 + 805 H -1.370222 -5.613724 -4.112042 20 800 + 806 H -0.783872 -5.696630 -6.601592 22 801 + 807 H -0.918682 -3.670337 -5.057847 24 802 + 808 H -0.051016 -3.481788 -6.645675 24 802 + 809 H 0.927863 -3.578685 -5.148034 24 802 + 810 H 1.304895 -7.011135 -6.510945 24 803 + 811 H 2.256941 -6.075607 -5.425529 24 803 + 812 H 1.836340 -5.473788 -7.076509 24 803 + 813 N 0.008587 -9.534155 -3.176981 7 796 814 817 + 814 CA -0.164006 -10.610017 -2.276861 8 813 815 818 819 + 815 C 0.455793 -10.123372 -0.937523 9 814 816 828 + 816 O 1.609433 -9.732719 -0.855349 11 815 + 817 HN 0.661532 -9.822276 -3.993714 10 813 + 818 H -1.244755 -10.767542 -2.035039 12 814 + 819 C 0.574437 -11.905679 -2.866050 156 814 820 824 825 + 820 C 0.334302 -13.196441 -2.052243 158 819 821 826 827 + 821 C 0.695999 -13.209957 -0.547494 160 820 822 823 + 822 O -0.264686 -13.183024 0.298109 161 821 + 823 O 1.910632 -13.459361 -0.183932 161 821 + 824 H 1.710862 -11.775851 -2.827976 157 819 + 825 H 0.358791 -11.917380 -3.993445 157 819 + 826 H 0.882365 -13.997962 -2.620937 159 820 + 827 H -0.759904 -13.530227 -2.138213 159 820 + 828 N -0.357453 -10.118381 0.156881 7 815 829 832 + 829 CA -0.126858 -9.579761 1.459753 8 828 830 833 834 + 830 C 1.210865 -9.885856 2.201894 9 829 831 840 + 831 O 1.578355 -9.098965 3.087348 11 830 + 832 HN -1.314386 -10.278297 -0.048400 10 828 + 833 H -0.027285 -8.417312 1.375403 12 829 + 834 C -1.323443 -9.874534 2.428279 140 829 835 838 839 + 835 C -2.796658 -9.594191 2.040205 142 834 836 837 + 836 O -3.598938 -8.858694 2.747148 143 835 + 837 O -3.069275 -9.875155 0.835441 143 835 + 838 H -1.081085 -9.350501 3.331576 141 834 + 839 H -1.329114 -10.904878 2.757681 141 834 + 840 N 1.774130 -11.086092 1.992881 1 830 841 844 + 841 CA 2.994120 -11.545091 2.708587 2 840 842 845 846 + 842 C 4.377665 -11.351494 1.943197 3 841 843 847 + 843 O 5.433148 -11.274449 2.624196 5 842 + 844 HN 1.231410 -11.794245 1.490134 4 840 + 845 H 3.087086 -10.934376 3.717487 6 841 + 846 H 2.994182 -12.632411 2.994368 6 841 + 847 N 4.334836 -11.180015 0.643592 7 842 848 851 + 848 CA 5.298784 -10.617673 -0.256284 8 847 849 852 853 + 849 C 5.545436 -9.161422 0.121481 9 848 850 871 + 850 O 4.681756 -8.523001 0.675460 11 849 + 851 HN 3.389098 -11.194600 0.224796 10 847 + 852 H 6.302556 -11.051188 -0.027697 12 848 + 853 C 4.842303 -10.729803 -1.752153 205 848 854 860 861 + 854 C 4.713323 -12.135756 -2.446341 207 853 855 862 863 + 855 C 5.630639 -13.213151 -1.906582 209 854 856 864 865 + 856 N 5.284941 -13.736409 -0.601898 211 855 857 866 + 857 C 6.075566 -13.904284 0.492928 213 856 858 859 + 858 N 7.378324 -13.682239 0.392183 214 857 867 868 + 859 N 5.537046 -14.223213 1.666359 214 857 869 870 + 860 H 5.533031 -10.123030 -2.400529 206 853 + 861 H 3.921522 -10.207566 -1.834451 206 853 + 862 H 4.892154 -12.013932 -3.582693 208 854 + 863 H 3.646766 -12.426728 -2.380513 208 854 + 864 H 6.696275 -12.970967 -1.977244 210 855 + 865 H 5.489916 -14.113101 -2.629388 210 855 + 866 HN 4.272537 -13.863270 -0.494816 212 856 + 867 HN 7.985377 -13.700052 -0.424821 215 858 + 868 HN 7.940470 -13.667672 1.245648 215 858 + 869 HN 4.531855 -14.502228 1.787659 215 859 + 870 HN 6.101298 -14.389973 2.557369 215 859 + 871 N 6.795959 -8.709417 -0.229618 7 849 872 875 + 872 CA 7.151484 -7.314826 -0.044504 33 871 873 876 877 + 873 C 6.772152 -6.618863 -1.344791 9 872 874 885 + 874 O 6.491580 -7.195037 -2.353138 11 873 + 875 HN 7.318576 -9.171415 -1.002843 10 871 + 876 H 6.525833 -6.859535 0.829338 12 872 + 877 C 8.635451 -7.121669 0.159249 38 872 878 879 880 + 878 OH 9.319110 -7.714935 -0.864105 42 877 881 + 879 C 9.122393 -7.761915 1.542275 40 877 882 883 884 + 880 H 8.861381 -6.006942 0.177513 39 877 + 881 HO 10.194312 -7.422946 -0.650194 43 878 + 882 H 10.121810 -7.432113 1.729501 41 879 + 883 H 9.135396 -8.869565 1.459149 41 879 + 884 H 8.446951 -7.382073 2.362364 41 879 + 885 N 6.963090 -5.264591 -1.254451 7 873 886 889 + 886 CA 6.942143 -4.382454 -2.396821 8 885 887 890 891 + 887 C 8.032255 -4.727919 -3.355290 9 886 888 904 + 888 O 7.874094 -4.700903 -4.606280 11 887 + 889 HN 7.090170 -4.902090 -0.328807 10 885 + 890 H 6.016462 -4.502766 -2.986232 12 886 + 891 C 7.011823 -2.893701 -1.884788 19 886 892 895 896 + 892 C 5.619258 -2.371640 -1.146601 21 891 893 894 897 + 893 C 5.747407 -0.832171 -0.836537 23 892 898 899 900 + 894 C 4.304852 -2.632042 -1.932473 23 892 901 902 903 + 895 H 7.232530 -2.302129 -2.742395 20 891 + 896 H 7.918264 -2.789406 -1.123344 20 891 + 897 H 5.453202 -2.916654 -0.186086 22 892 + 898 H 4.887008 -0.456110 -0.323416 24 893 + 899 H 5.896335 -0.152245 -1.791542 24 893 + 900 H 6.670665 -0.673450 -0.254409 24 893 + 901 H 4.181643 -2.082693 -2.916672 24 894 + 902 H 3.442444 -2.383879 -1.330292 24 894 + 903 H 4.282395 -3.716052 -2.117091 24 894 + 904 N 9.237825 -5.055680 -2.844670 7 887 905 908 + 905 CA 10.327506 -5.326158 -3.751795 33 904 906 909 910 + 906 C 10.299712 -6.687552 -4.448700 9 905 907 915 + 907 O 11.020799 -6.802866 -5.444496 11 906 + 908 HN 9.513335 -4.765910 -1.839355 10 904 + 909 H 10.385954 -4.560168 -4.527939 12 905 + 910 C 11.616785 -5.225390 -2.849555 34 905 911 912 913 + 911 OH 11.681845 -6.184576 -1.811464 36 910 914 + 912 H 11.731770 -4.245308 -2.404822 35 910 + 913 H 12.479811 -5.484003 -3.480128 35 910 + 914 HO 12.247855 -6.858858 -2.142458 37 911 + 915 N 9.390895 -7.583629 -4.036730 7 906 916 919 + 916 CA 8.992160 -8.754252 -4.825764 8 915 917 920 921 + 917 C 8.441950 -8.325775 -6.179531 9 916 918 927 + 918 O 8.453951 -9.076338 -7.106677 11 917 + 919 HN 8.901001 -7.489208 -3.091813 10 915 + 920 H 10.003891 -9.220020 -5.018515 12 916 + 921 C 8.053488 -9.759256 -4.183158 140 916 922 925 926 + 922 C 8.636121 -10.682406 -3.119472 142 921 923 924 + 923 O 8.285666 -10.472382 -1.922177 143 922 + 924 O 9.461725 -11.579888 -3.491527 143 922 + 925 H 7.570077 -10.438277 -4.930342 141 921 + 926 H 7.245571 -9.201184 -3.714526 141 921 + 927 N 7.768214 -7.119718 -6.199610 7 917 928 931 + 928 CA 7.005887 -6.638728 -7.315257 8 927 929 932 933 + 929 C 7.851617 -5.582566 -8.113333 9 928 930 948 + 930 O 7.595614 -5.232955 -9.268020 11 929 + 931 HN 7.640444 -6.594365 -5.349903 10 927 + 932 H 6.951423 -7.445998 -8.104085 12 928 + 933 C 5.604718 -6.020286 -6.971603 73 928 934 941 942 + 934 C 4.808080 -7.258931 -6.484822 75 933 935 936 + 935 C 4.589395 -7.461018 -5.120438 76 934 937 943 + 936 C 4.447069 -8.273894 -7.429155 76 934 938 944 + 937 C 3.784056 -8.535024 -4.755017 78 935 939 945 + 938 C 3.579283 -9.310814 -7.055696 78 936 939 946 + 939 C 3.326057 -9.397762 -5.690539 80 937 938 940 + 940 OH 2.439893 -10.287138 -5.195207 81 939 947 + 941 H 5.141919 -5.567564 -7.921399 74 933 + 942 H 5.606057 -5.151689 -6.311062 74 933 + 943 H 4.944905 -6.731723 -4.350204 77 935 + 944 H 4.660459 -8.167346 -8.489786 77 936 + 945 H 3.457378 -8.750277 -3.665145 79 937 + 946 H 3.267954 -10.081994 -7.761989 79 938 + 947 HO 2.186803 -10.747811 -5.996630 82 940 + 948 N 8.902051 -5.011864 -7.407302 7 929 949 952 + 949 CA 9.703612 -3.896573 -7.971331 8 948 950 953 954 + 950 C 8.854605 -2.738907 -8.339936 9 949 951 962 + 951 O 9.065146 -2.145748 -9.384005 11 950 + 952 HN 9.116746 -5.266463 -6.458188 10 948 + 953 H 10.386108 -3.586461 -7.092001 12 949 + 954 C 10.578732 -4.353776 -9.179322 150 949 955 958 959 + 955 C 11.689249 -3.400850 -9.487746 152 954 956 957 + 956 O 11.683048 -2.729553 -10.505813 153 955 + 957 N 12.685159 -3.379988 -8.534891 154 955 960 961 + 958 H 9.859055 -4.483921 -10.059621 151 954 + 959 H 11.053015 -5.363302 -8.978055 151 954 + 960 HN 12.816952 -4.073113 -7.744033 155 957 + 961 HN 13.500082 -2.669172 -8.653591 155 957 + 962 N 7.961974 -2.346899 -7.450123 7 950 963 966 + 963 CA 7.210073 -1.082393 -7.353242 8 962 964 967 968 + 964 C 8.220074 -0.014005 -6.989916 9 963 965 981 + 965 O 8.976625 -0.122583 -6.038982 11 964 + 966 HN 7.839428 -2.859206 -6.569147 10 962 + 967 H 6.707337 -0.850947 -8.383918 12 963 + 968 C 6.030095 -1.285349 -6.242570 25 963 969 970 972 + 969 C 4.899744 -1.930604 -7.085273 29 968 971 973 974 + 970 C 5.645671 -0.002619 -5.492558 27 968 975 976 977 + 971 C 3.850643 -2.639039 -6.295674 31 969 978 979 980 + 972 H 6.419510 -1.908236 -5.417144 26 968 + 973 H 5.364352 -2.708104 -7.784017 30 969 + 974 H 4.483419 -1.167649 -7.800574 30 969 + 975 H 5.004870 -0.066649 -4.602552 28 970 + 976 H 5.129294 0.689353 -6.215366 28 970 + 977 H 6.560668 0.460605 -5.074466 28 970 + 978 H 3.234235 -1.930388 -5.649940 32 971 + 979 H 4.384891 -3.374819 -5.577049 32 971 + 980 H 3.162458 -3.233503 -6.928627 32 971 + 981 N 8.279015 1.096767 -7.735473 7 964 982 985 + 982 CA 9.149500 2.177313 -7.448918 8 981 983 986 987 + 983 C 8.443049 3.455173 -7.091881 9 982 984 998 + 984 O 7.225838 3.588535 -7.314849 11 983 + 985 HN 7.643874 1.078344 -8.517521 10 981 + 986 H 9.726155 1.989811 -6.530547 12 982 + 987 C 10.141562 2.393897 -8.637297 170 982 988 992 993 + 988 C 11.175363 1.278751 -8.856450 172 987 989 994 995 + 989 C 12.297979 1.259017 -7.866598 174 988 990 991 + 990 O 13.426383 1.600621 -8.288936 175 989 + 991 N 12.128586 0.499484 -6.748544 176 989 996 997 + 992 H 10.711669 3.336580 -8.503837 171 987 + 993 H 9.628679 2.543322 -9.607849 171 987 + 994 H 11.602578 1.390889 -9.880921 173 988 + 995 H 10.646349 0.304077 -8.758295 173 988 + 996 HN 11.162328 0.324257 -6.474357 177 991 + 997 HN 12.859952 0.645961 -6.011600 177 991 + 998 N 9.290608 4.442003 -6.647564 7 983 999 1002 + 999 CA 8.811159 5.826111 -6.212163 8 998 1000 1003 1004 + 1000 C 7.909587 6.365352 -7.395189 9 999 1001 1020 + 1001 O 8.277887 6.147537 -8.576688 11 1000 + 1002 HN 10.326040 4.354253 -6.566650 10 998 + 1003 H 8.074366 5.700259 -5.392561 12 999 + 1004 C 9.995835 6.763127 -5.753453 185 999 1005 1009 1010 + 1005 C 11.134989 6.936166 -6.773871 187 1004 1006 1011 1012 + 1006 C 12.450245 7.429690 -6.051861 189 1005 1007 1013 1014 + 1007 C 12.385757 8.858415 -5.565813 191 1006 1008 1015 1016 + 1008 N 13.633988 9.413177 -5.138817 193 1007 1017 1018 1019 + 1009 H 10.292905 6.307034 -4.826845 186 1004 + 1010 H 9.733735 7.849575 -5.494064 186 1004 + 1011 H 10.808074 7.681538 -7.552779 188 1005 + 1012 H 11.297990 5.963599 -7.337475 188 1005 + 1013 H 13.159036 7.413697 -6.874982 190 1006 + 1014 H 12.808296 6.686485 -5.298299 190 1006 + 1015 H 11.641999 8.947159 -4.656213 192 1007 + 1016 H 11.959207 9.504307 -6.407475 192 1007 + 1017 HN 13.653846 10.372301 -4.854541 194 1008 + 1018 HN 14.288544 9.333898 -5.904378 194 1008 + 1019 HN 14.092755 8.836443 -4.392426 194 1008 + 1020 N 6.734291 6.959000 -7.083862 7 1000 1021 1024 + 1021 CA 5.689140 7.483124 -7.928906 8 1020 1022 1025 1026 + 1022 C 4.722565 6.430009 -8.546693 9 1021 1023 1035 + 1023 O 3.693452 6.803359 -9.036911 11 1022 + 1024 HN 6.540297 7.080673 -6.102459 10 1020 + 1025 H 4.958282 8.082892 -7.282649 12 1021 + 1026 C 6.303009 8.338869 -9.147185 156 1021 1027 1031 1032 + 1027 C 6.962321 9.683020 -8.698706 158 1026 1028 1033 1034 + 1028 C 6.113335 10.806050 -8.094806 160 1027 1029 1030 + 1029 O 5.314957 11.441914 -8.867803 161 1028 + 1030 O 6.281814 11.153556 -6.860003 161 1028 + 1031 H 5.501095 8.608142 -9.829181 157 1026 + 1032 H 7.017775 7.642829 -9.688511 157 1026 + 1033 H 7.483003 10.111296 -9.587458 159 1027 + 1034 H 7.840208 9.443341 -8.067185 159 1027 + 1035 N 4.989573 5.171451 -8.501981 7 1022 1036 1039 + 1036 CA 4.030569 4.128878 -8.960795 33 1035 1037 1040 1041 + 1037 C 2.659803 4.362057 -8.317970 9 1036 1038 1046 + 1038 O 2.633685 4.624499 -7.137127 11 1037 + 1039 HN 5.932873 4.885550 -8.132184 10 1035 + 1040 H 3.970653 4.088976 -10.125056 12 1036 + 1041 C 4.547974 2.736928 -8.477716 34 1036 1042 1043 1044 + 1042 OH 5.739602 2.385810 -9.103937 36 1041 1045 + 1043 H 3.830289 1.946588 -8.750291 35 1041 + 1044 H 4.757904 2.775726 -7.322086 35 1041 + 1045 HO 6.399052 2.573026 -8.460448 37 1042 + 1046 N 1.554928 4.204648 -9.116288 7 1037 1047 1050 + 1047 CA 0.143907 4.283937 -8.678656 33 1046 1048 1051 1052 + 1048 C -0.303717 2.830944 -8.588594 9 1047 1049 1060 + 1049 O -0.192844 2.048979 -9.526722 11 1048 + 1050 HN 1.755361 3.846256 -10.076285 10 1046 + 1051 H 0.145346 4.729291 -7.623107 12 1047 + 1052 C -0.896382 4.990465 -9.602777 38 1047 1053 1054 1055 + 1053 OH -0.546909 6.390258 -9.553197 42 1052 1056 + 1054 C -2.266687 5.014292 -9.040912 40 1052 1057 1058 1059 + 1055 H -0.839484 4.664962 -10.623152 39 1052 + 1056 HO -1.191403 6.852676 -10.030026 43 1053 + 1057 H -2.370256 5.547925 -8.077780 41 1054 + 1058 H -2.643323 3.985031 -8.945267 41 1054 + 1059 H -3.015295 5.554521 -9.684458 41 1054 + 1060 N -0.809824 2.397412 -7.387791 7 1048 1061 1064 + 1061 CA -1.543539 1.146508 -7.125034 8 1060 1062 1065 1066 + 1062 C -2.990030 1.446385 -7.471646 9 1061 1063 1079 + 1063 O -3.473985 2.523645 -7.085299 11 1062 + 1064 HN -0.918513 3.078458 -6.559929 10 1060 + 1065 H -1.082428 0.391021 -7.805730 12 1061 + 1066 C -1.383109 0.737389 -5.704209 19 1061 1067 1070 1071 + 1067 C 0.156980 0.778637 -5.025094 21 1066 1068 1069 1072 + 1068 C 0.184063 0.045177 -3.655495 23 1067 1073 1074 1075 + 1069 C 1.197637 0.213126 -5.986021 23 1067 1076 1077 1078 + 1070 H -1.814061 -0.254567 -5.578464 20 1066 + 1071 H -2.073414 1.403223 -5.171331 20 1066 + 1072 H 0.570353 1.840354 -4.807618 22 1067 + 1073 H -0.614353 0.329349 -2.926832 24 1068 + 1074 H 1.166261 0.241414 -3.114555 24 1068 + 1075 H 0.023700 -1.069031 -3.783533 24 1068 + 1076 H 2.158203 0.044818 -5.470973 24 1069 + 1077 H 1.222442 1.006598 -6.769381 24 1069 + 1078 H 0.965216 -0.653562 -6.606231 24 1069 + 1079 N -3.781136 0.498160 -8.148625 7 1062 1080 1083 + 1080 CA -5.195999 0.627079 -8.395144 8 1079 1081 1084 1085 + 1081 C -5.839586 -0.173798 -7.325540 9 1080 1082 1097 + 1082 O -5.682825 -1.396726 -7.207748 11 1081 + 1083 HN -3.423672 -0.475658 -8.058410 10 1079 + 1084 H -5.466443 1.726348 -8.275345 12 1080 + 1085 C -5.700075 0.093076 -9.698941 109 1080 1086 1091 1092 + 1086 C -5.439579 1.075796 -10.855403 111 1085 1087 1088 + 1087 N -6.279526 2.029710 -11.458307 112 1086 1089 1093 + 1088 C -4.192293 1.220658 -11.582303 114 1086 1090 1094 + 1089 C -5.690995 2.592928 -12.533727 116 1087 1090 1095 + 1090 N -4.422291 2.142927 -12.597346 118 1088 1089 1096 + 1091 H -6.836699 -0.066381 -9.723009 110 1085 + 1092 H -5.265040 -0.930234 -9.855749 110 1085 + 1093 HN -7.252692 2.264574 -11.108175 113 1087 + 1094 H -3.349838 0.582035 -11.517840 115 1088 + 1095 H -6.306793 3.255586 -13.155877 117 1089 + 1096 HN -3.777635 2.395819 -13.330102 119 1090 + 1097 N -6.626714 0.438016 -6.407006 7 1081 1098 1101 + 1098 CA -7.321255 -0.209395 -5.260830 8 1097 1099 1102 1103 + 1099 C -8.726044 -0.540624 -5.779334 9 1098 1100 1116 + 1100 O -9.643748 0.246853 -6.020516 11 1099 + 1101 HN -6.861887 1.458160 -6.506142 10 1097 + 1102 H -6.783811 -1.126314 -4.931556 12 1098 + 1103 C -7.394204 0.687745 -4.053531 19 1098 1104 1107 1108 + 1104 C -8.296909 0.064749 -2.869849 21 1103 1105 1106 1109 + 1105 C -7.951698 -1.454279 -2.487926 23 1104 1110 1111 1112 + 1106 C -8.060038 0.927044 -1.568059 23 1104 1113 1114 1115 + 1107 H -7.854595 1.761490 -4.347062 20 1103 + 1108 H -6.360197 0.997945 -3.694450 20 1103 + 1109 H -9.450918 0.148422 -3.062584 22 1104 + 1110 H -7.020548 -1.637465 -1.993488 24 1105 + 1111 H -7.993278 -2.155479 -3.352501 24 1105 + 1112 H -8.718116 -1.826418 -1.776705 24 1105 + 1113 H -6.906806 1.040935 -1.329769 24 1106 + 1114 H -8.507678 0.388091 -0.676703 24 1106 + 1115 H -8.513627 1.951825 -1.684662 24 1106 + 1116 N -8.874500 -1.873711 -5.910632 7 1099 1117 1120 + 1117 CA -10.054693 -2.628336 -6.198564 8 1116 1118 1121 1122 + 1118 C -10.572111 -3.015072 -4.753004 9 1117 1119 1132 + 1119 O -9.832635 -3.443205 -3.816546 11 1118 + 1120 HN -7.996568 -2.422971 -5.836674 10 1116 + 1121 H -10.870694 -1.994424 -6.483439 12 1117 + 1122 C -9.759279 -3.959835 -7.069730 15 1117 1123 1124 1125 + 1123 C -10.946970 -4.877626 -7.068986 17 1122 1126 1127 1128 + 1124 C -9.371460 -3.542046 -8.470112 17 1122 1129 1130 1131 + 1125 H -8.949402 -4.516022 -6.543614 16 1122 + 1126 H -11.541359 -4.965020 -6.098983 18 1123 + 1127 H -10.625500 -5.914327 -7.249472 18 1123 + 1128 H -11.748695 -4.562709 -7.779917 18 1123 + 1129 H -8.371018 -3.050033 -8.468892 18 1124 + 1130 H -10.059019 -2.758287 -8.851634 18 1124 + 1131 H -9.340042 -4.349447 -9.290806 18 1124 + 1132 N -11.926250 -3.006119 -4.579854 7 1118 1133 1136 + 1133 CA -12.599868 -3.427499 -3.271795 8 1132 1134 1137 1138 + 1134 C -13.119425 -4.819080 -3.443024 9 1133 1135 1151 + 1135 O -13.506292 -5.208366 -4.502651 11 1134 + 1136 HN -12.484786 -2.940272 -5.402807 10 1132 + 1137 H -11.809544 -3.497303 -2.534649 12 1133 + 1138 C -13.689712 -2.401148 -2.755481 19 1133 1139 1142 1143 + 1139 C -13.005610 -1.020901 -2.289793 21 1138 1140 1141 1144 + 1140 C -13.886801 0.170603 -2.491323 23 1139 1145 1146 1147 + 1141 C -12.530133 -1.092500 -0.802600 23 1139 1148 1149 1150 + 1142 H -14.252193 -2.898736 -1.884096 20 1138 + 1143 H -14.401815 -2.226641 -3.620690 20 1138 + 1144 H -12.072590 -0.884860 -2.820312 22 1139 + 1145 H -13.445227 1.217778 -2.222189 24 1140 + 1146 H -14.793098 0.063548 -1.909740 24 1140 + 1147 H -14.187182 0.152067 -3.578149 24 1140 + 1148 H -13.308581 -1.365227 -0.079185 24 1141 + 1149 H -12.103016 -0.144811 -0.412295 24 1141 + 1150 H -11.612023 -1.776214 -0.714294 24 1141 + 1151 N -13.156998 -5.622978 -2.323616 7 1134 1152 1155 + 1152 CA -13.787861 -6.967978 -2.285282 8 1151 1153 1156 1157 + 1153 C -15.146212 -6.800506 -1.593340 9 1152 1154 1175 + 1154 O -15.158053 -6.442067 -0.396674 11 1153 + 1155 HN -12.804286 -5.282526 -1.428142 10 1151 + 1156 H -13.916618 -7.485164 -3.412935 12 1152 + 1157 C -12.946414 -7.979280 -1.497063 205 1152 1158 1164 1165 + 1158 C -13.667631 -9.245528 -0.905442 207 1157 1159 1166 1167 + 1159 C -12.815857 -10.499980 -0.801429 209 1158 1160 1168 1169 + 1160 N -11.666913 -10.382988 0.124040 211 1159 1161 1170 + 1161 C -10.598009 -11.176366 0.312631 213 1160 1162 1163 + 1162 N -10.307009 -12.288930 -0.364431 214 1161 1171 1172 + 1163 N -9.633279 -10.774307 1.106366 214 1161 1173 1174 + 1164 H -12.386465 -7.607216 -0.581206 206 1157 + 1165 H -12.215820 -8.370972 -2.244713 206 1157 + 1166 H -14.479446 -9.568262 -1.529164 208 1158 + 1167 H -14.129833 -9.168539 0.056180 208 1158 + 1168 H -12.412465 -10.669174 -1.854364 210 1159 + 1169 H -13.466079 -11.423733 -0.479836 210 1159 + 1170 HN -11.512692 -9.382182 0.495625 212 1160 + 1171 HN -10.805304 -12.650925 -1.216224 215 1162 + 1172 HN -9.470321 -12.815770 -0.049797 215 1162 + 1173 HN -9.791948 -9.915404 1.677222 215 1163 + 1174 HN -8.883682 -11.348748 1.394071 215 1163 + 1175 N -16.257217 -7.220554 -2.308703 7 1153 1176 1179 + 1176 CA -17.613518 -7.141694 -1.748926 8 1175 1177 1180 1181 + 1177 C -17.781416 -8.219845 -0.663951 9 1176 1178 1194 + 1178 O -17.284390 -9.348310 -0.956865 11 1177 + 1179 HN -16.199694 -7.696122 -3.255195 10 1175 + 1180 H -17.779696 -6.166353 -1.252915 12 1176 + 1181 C -18.748459 -7.363962 -2.843069 19 1176 1182 1185 1186 + 1182 C -18.849202 -6.260828 -3.989572 21 1181 1183 1184 1187 + 1183 C -19.614490 -6.870808 -5.148395 23 1182 1188 1189 1190 + 1184 C -19.500680 -4.982113 -3.494742 23 1182 1191 1192 1193 + 1185 H -19.731301 -7.397251 -2.283025 20 1181 + 1186 H -18.632820 -8.422553 -3.243609 20 1181 + 1187 H -17.781339 -6.071752 -4.343559 22 1182 + 1188 H -19.542258 -6.264447 -6.144731 24 1183 + 1189 H -20.684366 -6.894552 -4.987517 24 1183 + 1190 H -19.302207 -7.942787 -5.285929 24 1183 + 1191 H -19.636746 -4.174795 -4.365113 24 1184 + 1192 H -18.901688 -4.545004 -2.684455 24 1184 + 1193 H -20.591982 -5.186371 -3.176857 24 1184 + 1194 N -18.472240 -7.923944 0.433190 7 1177 1195 1198 + 1195 CA -18.558377 -8.661913 1.684016 8 1194 1196 1199 1200 + 1196 C -19.865592 -8.197617 2.423657 9 1195 1197 1218 + 1197 O -20.225574 -7.007408 2.517047 11 1196 + 1198 HN -19.018633 -7.045923 0.383040 10 1194 + 1199 H -18.591712 -9.815151 1.449892 12 1195 + 1200 C -17.330534 -8.352242 2.590189 205 1195 1201 1207 1208 + 1201 C -17.197501 -9.255175 3.894695 207 1200 1202 1209 1210 + 1202 C -15.917138 -8.993799 4.761448 209 1201 1203 1211 1212 + 1203 N -15.862754 -7.604311 5.340549 211 1202 1204 1213 + 1204 C -14.953946 -7.213621 6.222257 213 1203 1205 1206 + 1205 N -13.939504 -7.925565 6.768523 214 1204 1214 1215 + 1206 N -15.231901 -6.019110 6.758979 214 1204 1216 1217 + 1207 H -17.334188 -7.257380 2.696147 206 1200 + 1208 H -16.422266 -8.568012 1.978366 206 1200 + 1209 H -17.281791 -10.298139 3.520877 208 1201 + 1210 H -18.121600 -9.053051 4.460330 208 1201 + 1211 H -14.891329 -9.193895 4.266694 210 1202 + 1212 H -16.028045 -9.747706 5.563074 210 1202 + 1213 HN -16.694442 -6.992689 5.266552 212 1203 + 1214 HN -13.473108 -8.806088 6.384760 215 1205 + 1215 HN -13.382022 -7.560903 7.513773 215 1205 + 1216 HN -16.061939 -5.573954 6.401806 215 1206 + 1217 HN -14.719788 -5.491070 7.406533 215 1206 + 1218 N -20.555642 -9.238644 2.984101 1 1196 1219 1222 + 1219 CA -21.702627 -8.980829 3.816986 2 1218 1220 1223 1224 + 1220 C -22.667592 -10.144922 3.908536 3 1219 1221 1225 + 1221 O -23.356911 -10.299018 4.988328 5 1220 + 1222 HN -20.172384 -10.204330 3.007070 4 1218 + 1223 H -21.390921 -8.619000 4.839945 6 1219 + 1224 H -22.324153 -8.174944 3.384408 6 1219 + 1225 N -22.722375 -11.026698 2.860636 1 1220 1226 1229 + 1226 CA -23.459566 -12.247827 2.845542 2 1225 1227 1230 1231 + 1227 C -22.978621 -13.438108 1.985225 238 1226 1228 1232 + 1228 O -23.756241 -13.995796 1.178096 239 1227 + 1229 HN -22.154953 -11.003456 1.998676 4 1225 + 1230 H -23.492303 -12.585024 3.945342 6 1226 + 1231 H -24.562029 -11.982169 2.632418 6 1226 + 1232 O -21.741623 -13.731454 2.030156 239 1227 + 1233 O -25.305889 -8.873286 2.603094 402 1234 1235 + 1234 H -26.195231 -8.788006 2.967312 403 1233 + 1235 H -25.362163 -9.790033 2.275871 403 1233 + 1236 O 1.912477 -17.151817 -13.840126 402 1237 1238 + 1237 H 1.018390 -17.464992 -13.630219 403 1236 + 1238 H 2.439262 -17.334772 -13.036215 403 1236 + 1239 O 8.975970 -6.483371 7.068342 402 1240 1241 + 1240 H 8.251083 -5.855922 6.942323 403 1239 + 1241 H 9.786320 -5.989537 6.904165 403 1239 + 1242 O -17.059429 -6.682892 -18.382532 402 1243 1244 + 1243 H -17.356881 -6.533480 -19.279335 403 1242 + 1244 H -16.147993 -6.804945 -18.480643 403 1242 + 1245 O 11.369980 -7.303894 20.323145 402 1246 1247 + 1246 H 10.458255 -7.203431 20.535809 403 1245 + 1247 H 11.777545 -7.941380 20.905100 403 1245 + 1248 O 3.047993 13.115234 13.513593 402 1249 1250 + 1249 H 2.189597 12.815932 13.781761 403 1248 + 1250 H 3.351020 13.772449 14.197587 403 1248 + 1251 O 9.177488 -19.531354 -17.025005 402 1252 1253 + 1252 H 8.997180 -19.923922 -17.884170 403 1251 + 1253 H 8.309703 -19.391487 -16.606802 403 1251 + 1254 O -23.848340 -5.791211 7.441678 402 1255 1256 + 1255 H -24.004055 -6.746691 7.261738 403 1254 + 1256 H -23.114081 -5.501409 6.867622 403 1254 + 1257 O 20.312209 0.171955 -11.773561 402 1258 1259 + 1258 H 20.146745 1.095650 -12.020368 403 1257 + 1259 H 21.238842 0.205679 -11.456820 403 1257 + 1260 O -22.314798 3.014770 5.149047 402 1261 1262 + 1261 H -22.929289 2.276522 4.980524 403 1260 + 1262 H -22.201264 3.090196 6.138941 403 1260 + 1263 O 26.239381 8.286972 11.597675 402 1264 1265 + 1264 H 26.254621 7.398022 11.997034 403 1263 + 1265 H 26.842192 8.820608 12.190091 403 1263 + 1266 O 1.081563 20.255845 0.892389 402 1267 1268 + 1267 H 0.921065 19.278377 0.845371 403 1266 + 1268 H 1.812904 20.277503 0.290341 403 1266 + 1269 O -25.838005 -18.994104 1.429638 402 1270 1271 + 1270 H -26.326160 -18.188143 1.703932 403 1269 + 1271 H -25.342908 -19.303427 2.200872 403 1269 + 1272 O -20.846054 -7.092652 6.478370 402 1273 1274 + 1273 H -20.166552 -7.554414 6.018306 403 1272 + 1274 H -21.115422 -7.596368 7.225200 403 1272 + 1275 O 25.160173 -4.728893 -15.381523 402 1276 1277 + 1276 H 24.661069 -4.062502 -14.979503 403 1275 + 1277 H 25.990165 -4.238213 -15.567710 403 1275 + 1278 O 14.535913 -19.677013 15.675709 402 1279 1280 + 1279 H 14.037278 -20.588075 15.600840 403 1278 + 1280 H 14.211502 -19.181601 14.912412 403 1278 + 1281 O 2.857645 5.855417 4.079262 402 1282 1283 + 1282 H 3.430506 5.710138 4.830199 403 1281 + 1283 H 2.475458 6.741420 4.276791 403 1281 + 1284 O -27.372739 -15.194690 -19.205198 402 1285 1286 + 1285 H -28.210581 -15.653921 -19.162899 403 1284 + 1286 H -27.456185 -14.667250 -19.960242 403 1284 + 1287 O 17.781541 0.602750 -19.513277 402 1288 1289 + 1288 H 17.110642 0.664367 -18.792643 403 1287 + 1289 H 18.099117 1.530660 -19.555262 403 1287 + 1290 O 8.088032 9.439765 10.567445 402 1291 1292 + 1291 H 8.015346 10.287070 10.169518 403 1290 + 1292 H 8.124832 9.462611 11.569641 403 1290 + 1293 O 15.345860 8.714934 -11.152067 402 1294 1295 + 1294 H 15.658920 9.075500 -11.972725 403 1293 + 1295 H 14.523818 9.211910 -11.028938 403 1293 + 1296 O 11.013253 17.283874 -4.348263 402 1297 1298 + 1297 H 10.789838 18.205570 -4.504969 403 1296 + 1298 H 10.260676 16.779106 -4.055437 403 1296 + 1299 O -12.889592 -16.760154 20.387880 402 1300 1301 + 1300 H -13.380671 -16.152118 19.799845 403 1299 + 1301 H -13.369275 -16.639729 21.191087 403 1299 + 1302 O 25.866516 4.706708 -8.061449 402 1303 1304 + 1303 H 25.769362 4.461317 -8.965208 403 1302 + 1304 H 25.764828 5.656105 -8.114825 403 1302 + 1305 O -26.248807 10.809987 -17.556369 402 1306 1307 + 1306 H -25.862537 10.639607 -16.669023 403 1305 + 1307 H -25.586772 10.275331 -18.075376 403 1305 + 1308 O 5.011891 -0.095276 11.102149 402 1309 1310 + 1309 H 5.950070 -0.328570 10.928116 403 1308 + 1310 H 4.658035 -0.692033 11.838618 403 1308 + 1311 O -3.238023 12.776925 -11.754925 402 1312 1313 + 1312 H -3.559468 13.177496 -12.562608 403 1311 + 1313 H -2.242036 12.949361 -11.730152 403 1311 + 1314 O 7.608155 6.209090 6.533228 402 1315 1316 + 1315 H 6.751309 6.368791 6.939913 403 1314 + 1316 H 7.470608 5.288476 6.273733 403 1314 + 1317 O 14.666135 -14.922987 -11.755230 402 1318 1319 + 1318 H 14.581988 -14.800079 -10.784928 403 1317 + 1319 H 15.226569 -14.207434 -12.104465 403 1317 + 1320 O 15.326386 3.732831 -20.745668 402 1321 1322 + 1321 H 14.863781 4.277641 -20.063559 403 1320 + 1322 H 14.723700 3.157686 -21.298124 403 1320 + 1323 O 18.627348 -11.469990 6.467592 402 1324 1325 + 1324 H 19.047503 -12.239416 6.986935 403 1323 + 1325 H 19.345653 -10.823603 6.332871 403 1323 + 1326 O -14.220347 1.309533 12.809953 402 1327 1328 + 1327 H -15.112916 1.674865 12.966390 403 1326 + 1328 H -13.905824 1.691626 11.972749 403 1326 + 1329 O 17.738294 20.743473 -0.318702 402 1330 1331 + 1330 H 16.798924 21.074482 -0.373811 403 1329 + 1331 H 18.299449 21.160545 -1.000515 403 1329 + 1332 O 20.455752 2.132791 12.340284 402 1333 1334 + 1333 H 19.810773 1.395571 12.257305 403 1332 + 1334 H 20.198026 2.647549 11.503824 403 1332 + 1335 O 9.853022 -4.726683 18.073966 402 1336 1337 + 1336 H 9.922207 -4.319154 18.942345 403 1335 + 1337 H 10.745493 -4.795112 17.634995 403 1335 + 1338 O 22.828162 7.406766 18.911442 402 1339 1340 + 1339 H 23.277041 7.740752 18.085874 403 1338 + 1340 H 21.875678 7.287001 18.697167 403 1338 + 1341 O 12.857348 6.858682 -2.850558 402 1342 1343 + 1342 H 12.349544 7.638411 -2.700800 403 1341 + 1343 H 13.434641 6.773930 -2.100368 403 1341 + 1344 O 10.156535 2.406121 -18.658294 402 1345 1346 + 1345 H 10.409878 1.989225 -19.465922 403 1344 + 1346 H 9.490048 3.103188 -18.852928 403 1344 + 1347 O 12.554233 20.216080 19.570476 402 1348 1349 + 1348 H 11.705682 19.810667 19.782475 403 1347 + 1349 H 12.468266 20.347772 18.588160 403 1347 + 1350 O -1.134276 6.357754 18.934733 402 1351 1352 + 1351 H -1.973226 6.075942 19.245633 403 1350 + 1352 H -0.442075 6.043387 19.552910 403 1350 + 1353 O 1.750577 4.009032 13.244051 402 1354 1355 + 1354 H 1.218838 4.545834 13.791599 403 1353 + 1355 H 1.398756 3.100724 13.349288 403 1353 + 1356 O 2.689021 16.465513 4.587974 402 1357 1358 + 1357 H 3.467483 16.279752 5.178457 403 1356 + 1358 H 3.010897 17.110882 3.971315 403 1356 + 1359 O 22.627367 7.401815 -6.857148 402 1360 1361 + 1360 H 21.892213 7.078953 -7.539727 403 1359 + 1361 H 22.599466 6.767179 -6.162623 403 1359 + 1362 O -24.350411 -14.025041 19.899958 402 1363 1364 + 1363 H -23.879390 -13.314568 19.375377 403 1362 + 1364 H -25.008554 -14.400223 19.294992 403 1362 + 1365 O 18.357304 9.543924 6.204099 402 1366 1367 + 1366 H 18.326985 9.093740 5.378574 403 1365 + 1367 H 19.117744 9.183856 6.709862 403 1365 + 1368 O 21.017970 -11.520615 -11.071883 402 1369 1370 + 1369 H 21.726613 -10.894899 -10.978046 403 1368 + 1370 H 20.726915 -11.629983 -10.116083 403 1368 + 1371 O -26.667012 4.365972 15.083664 402 1372 1373 + 1372 H -27.091443 3.550925 15.267577 403 1371 + 1373 H -25.989136 4.193758 14.444620 403 1371 + 1374 O 12.781386 0.642540 16.526237 402 1375 1376 + 1375 H 13.038723 1.476289 17.006927 403 1374 + 1376 H 12.089659 0.933072 15.871227 403 1374 + 1377 O -27.429715 -6.725581 8.240721 402 1378 1379 + 1378 H -26.910936 -6.564480 7.470893 403 1377 + 1379 H -28.162464 -7.327953 7.969065 403 1377 + 1380 O 24.070362 5.174514 -0.911512 402 1381 1382 + 1381 H 24.629840 5.966148 -0.705486 403 1380 + 1382 H 23.362520 5.287238 -1.509298 403 1380 + 1383 O 16.846666 -16.995462 -13.603864 402 1384 1385 + 1384 H 15.867560 -16.748669 -13.456021 403 1383 + 1385 H 17.071846 -16.254095 -14.246763 403 1383 + 1386 O 20.841116 12.797120 17.009497 402 1387 1388 + 1387 H 20.969187 13.669803 17.421731 403 1386 + 1388 H 21.771225 12.416689 16.764510 403 1386 + 1389 O -19.221734 -18.875573 -10.983743 402 1390 1391 + 1390 H -20.186979 -18.779925 -10.982038 403 1389 + 1391 H -19.009681 -19.369621 -10.158798 403 1389 + 1392 O -18.683521 -20.505972 -16.031221 402 1393 1394 + 1393 H -19.618898 -20.618800 -16.082058 403 1392 + 1394 H -18.315789 -21.292104 -15.650396 403 1392 + 1395 O 13.486524 6.749112 5.293446 402 1396 1397 + 1396 H 13.961609 6.056192 4.983058 403 1395 + 1397 H 12.780504 7.007906 4.716738 403 1395 + 1398 O 20.810382 20.409198 13.765268 402 1399 1400 + 1399 H 21.268029 20.454532 14.598864 403 1398 + 1400 H 19.895912 20.318361 13.998352 403 1398 + 1401 O 20.363727 -12.785030 1.387420 402 1402 1403 + 1402 H 20.625728 -12.042183 1.970150 403 1401 + 1403 H 19.472843 -13.114509 1.692870 403 1401 + 1404 O -4.110768 13.121183 -4.644500 402 1405 1406 + 1405 H -3.600734 12.558925 -4.032909 403 1404 + 1406 H -4.403120 13.867412 -4.044378 403 1404 + 1407 O -21.061840 -7.740629 20.493954 402 1408 1409 + 1408 H -21.039453 -7.543946 19.536841 403 1407 + 1409 H -21.757349 -7.146898 20.900973 403 1407 + 1410 O 26.211082 -13.851944 -14.351632 402 1411 1412 + 1411 H 26.688652 -13.578058 -13.560156 403 1410 + 1412 H 25.237610 -13.844318 -14.168406 403 1410 + 1413 O 7.682001 -20.605822 4.285305 402 1414 1415 + 1414 H 8.364066 -21.007718 3.810153 403 1413 + 1415 H 7.192709 -19.999465 3.748655 403 1413 + 1416 O 22.004930 15.161537 5.915259 402 1417 1418 + 1417 H 22.529069 15.401145 5.140758 403 1416 + 1418 H 21.836857 14.241604 6.044353 403 1416 + 1419 O 21.713613 -17.900383 3.815703 402 1420 1421 + 1420 H 22.679247 -17.725384 3.950726 403 1419 + 1421 H 21.695664 -18.649618 3.180406 403 1419 + 1422 O 11.567159 -18.128823 12.553393 402 1423 1424 + 1423 H 11.856655 -17.178344 12.428270 403 1422 + 1424 H 11.248307 -18.230630 13.449380 403 1422 + 1425 O -22.622068 18.057993 -12.095565 402 1426 1427 + 1426 H -21.694228 17.853670 -11.941877 403 1425 + 1427 H -22.819172 17.835208 -12.993248 403 1425 + 1428 O 9.275007 12.390062 -11.584253 402 1429 1430 + 1429 H 8.977379 13.016934 -10.914605 403 1428 + 1430 H 10.127813 12.041771 -11.232361 403 1428 + 1431 O -14.822916 -15.989738 9.135198 402 1432 1433 + 1432 H -14.194812 -16.628214 9.459309 403 1431 + 1433 H -14.342626 -15.188459 9.014917 403 1431 + 1434 O -11.828358 -9.561319 -4.583271 402 1435 1436 + 1435 H -12.150096 -9.065398 -5.351378 403 1434 + 1436 H -12.516681 -10.185548 -4.230080 403 1434 + 1437 O -10.898855 6.281982 -10.651011 402 1438 1439 + 1438 H -11.533704 6.844824 -10.249357 403 1437 + 1439 H -10.394778 5.928734 -9.945580 403 1437 + 1440 O 10.206251 18.878731 19.697794 402 1441 1442 + 1441 H 10.128033 18.397864 20.526746 403 1440 + 1442 H 9.368907 19.321892 19.635002 403 1440 + 1443 O 7.056097 15.592239 15.029949 402 1444 1445 + 1444 H 7.186116 15.478315 14.072096 403 1443 + 1445 H 7.414569 14.832987 15.435389 403 1443 + 1446 O 24.543977 3.489901 -14.044452 402 1447 1448 + 1447 H 23.682275 3.287251 -13.651175 403 1446 + 1448 H 24.372867 3.165473 -14.930902 403 1446 + 1449 O -0.579079 -10.101283 9.711937 402 1450 1451 + 1450 H -1.148742 -10.353328 9.005933 403 1449 + 1451 H -0.914837 -9.213566 9.976954 403 1449 + 1452 O 6.810722 17.081705 -5.703105 402 1453 1454 + 1453 H 5.903603 16.716054 -5.813888 403 1452 + 1454 H 7.038830 17.199405 -6.631357 403 1452 + 1455 O -26.352729 7.462163 20.420411 402 1456 1457 + 1456 H -27.199047 7.711650 20.831378 403 1455 + 1457 H -26.411228 7.671245 19.444854 403 1455 + 1458 O 17.042652 1.713603 8.364686 402 1459 1460 + 1459 H 16.951087 0.795520 8.175385 403 1458 + 1460 H 16.736372 2.035025 7.509624 403 1458 + 1461 O 19.131873 19.334012 -6.335242 402 1462 1463 + 1462 H 18.416265 18.729295 -6.454050 403 1461 + 1463 H 19.910836 18.805924 -6.078777 403 1461 + 1464 O 7.310440 -10.543485 13.587642 402 1465 1466 + 1465 H 6.863481 -11.404338 13.838041 403 1464 + 1466 H 6.716557 -9.980934 13.023023 403 1464 + 1467 O 16.655451 5.245734 12.848556 402 1468 1469 + 1468 H 17.418946 5.791006 12.911180 403 1467 + 1469 H 16.851104 4.455072 13.419371 403 1467 + 1470 O -11.098331 12.748199 -7.329972 402 1471 1472 + 1471 H -11.009338 13.599863 -7.754046 403 1470 + 1472 H -12.065844 12.538087 -7.393876 403 1470 + 1473 O -12.334041 -5.457784 -13.381783 402 1474 1475 + 1474 H -12.711013 -4.568395 -13.257780 403 1473 + 1475 H -11.461517 -5.234972 -13.709702 403 1473 + 1476 O -19.619563 15.046747 6.026220 402 1477 1478 + 1477 H -19.064160 15.888434 5.869584 403 1476 + 1478 H -20.197675 14.948767 5.270745 403 1476 + 1479 O 19.403362 5.853957 6.190263 402 1480 1481 + 1480 H 18.497327 6.115780 6.469846 403 1479 + 1481 H 20.017752 6.471645 6.487352 403 1479 + 1482 O -25.726372 -3.750023 6.981390 402 1483 1484 + 1483 H -26.510590 -3.855351 7.566875 403 1482 + 1484 H -25.108784 -4.364237 7.293376 403 1482 + 1485 O 19.363936 -15.722056 8.477199 402 1486 1487 + 1486 H 19.376520 -16.156352 9.371325 403 1485 + 1487 H 20.131991 -16.106093 8.026790 403 1485 + 1488 O 4.918015 16.654603 6.129016 402 1489 1490 + 1489 H 5.581517 17.300026 5.845056 403 1488 + 1490 H 5.390842 15.802197 6.094486 403 1488 + 1491 O 6.078733 16.693115 -13.842069 402 1492 1493 + 1492 H 5.199251 16.442614 -14.064650 403 1491 + 1493 H 6.443869 16.763088 -14.767416 403 1491 + 1494 O 21.731326 -12.551581 -19.815904 402 1495 1496 + 1495 H 21.519077 -11.572592 -19.819800 403 1494 + 1496 H 21.264568 -12.901316 -18.987186 403 1494 + 1497 O 24.487045 0.545827 12.845924 402 1498 1499 + 1498 H 24.038085 0.883409 12.081688 403 1497 + 1499 H 24.083597 0.980384 13.591108 403 1497 + 1500 O 18.410889 -13.655540 -1.593840 402 1501 1502 + 1501 H 18.336634 -14.202424 -0.852695 403 1500 + 1502 H 19.187521 -13.942267 -2.059694 403 1500 + 1503 O 10.380738 17.460434 -20.015294 402 1504 1505 + 1504 H 9.800569 16.677901 -20.098710 403 1503 + 1505 H 10.044263 17.935616 -19.257888 403 1503 + 1506 O 13.540400 13.359091 -2.277273 402 1507 1508 + 1507 H 13.918768 14.199197 -2.621352 403 1506 + 1508 H 13.546416 13.374894 -1.268707 403 1506 + 1509 O 19.550822 -15.885302 -17.171256 402 1510 1511 + 1510 H 19.618925 -16.577230 -17.813037 403 1509 + 1511 H 20.364869 -15.924821 -16.745913 403 1509 + 1512 O 8.934453 -16.027660 20.082161 402 1513 1514 + 1513 H 8.350825 -15.432721 20.504320 403 1512 + 1514 H 9.504005 -15.407057 19.696244 403 1512 + 1515 O 13.449317 -0.696209 -11.399773 402 1516 1517 + 1516 H 14.259684 -0.816041 -10.861718 403 1515 + 1517 H 12.841649 -1.407477 -11.030433 403 1515 + 1518 O 21.159598 -20.230615 11.116255 402 1519 1520 + 1519 H 20.955379 -21.039069 10.677683 403 1518 + 1520 H 21.227629 -20.467861 12.046012 403 1518 + 1521 O -11.425719 10.313603 15.561621 402 1522 1523 + 1522 H -11.752060 9.489612 15.149018 403 1521 + 1523 H -12.009787 11.024201 15.339594 403 1521 + 1524 O 23.530234 5.073332 12.308815 402 1525 1526 + 1525 H 23.411228 4.192303 12.037314 403 1524 + 1526 H 23.017800 5.539035 11.565588 403 1524 + 1527 O 9.285394 15.401019 4.247587 402 1528 1529 + 1528 H 9.029223 16.111512 4.827382 403 1527 + 1529 H 9.908946 14.931813 4.786975 403 1527 + 1530 O 26.710953 10.879732 17.565984 402 1531 1532 + 1531 H 26.481837 11.014223 18.458503 403 1530 + 1532 H 26.801930 11.751805 17.193691 403 1530 + 1533 O 26.059219 -18.322514 -8.230640 402 1534 1535 + 1534 H 25.468209 -17.831491 -8.807599 403 1533 + 1535 H 26.660395 -17.588693 -7.832128 403 1533 + 1536 O 7.573847 10.494945 -13.000340 402 1537 1538 + 1537 H 6.752773 10.585941 -12.508913 403 1536 + 1538 H 8.060915 11.203548 -12.596091 403 1536 + 1539 O 16.495334 16.907261 -17.264088 402 1540 1541 + 1540 H 15.936311 17.701142 -17.215765 403 1539 + 1541 H 16.146725 16.404479 -17.972530 403 1539 + 1542 O 12.550501 12.792681 0.441559 402 1543 1544 + 1543 H 12.890193 12.783948 1.424080 403 1542 + 1544 H 12.972043 11.976735 0.117581 403 1542 + 1545 O 6.804544 2.469256 9.043785 402 1546 1547 + 1546 H 7.053760 2.925055 9.856512 403 1545 + 1547 H 7.365554 1.678918 9.065958 403 1545 + 1548 O -26.111190 11.845380 12.004953 402 1549 1550 + 1549 H -26.772515 12.430684 11.621087 403 1548 + 1550 H -25.209540 12.292191 11.872070 403 1548 + 1551 O -10.314383 -9.317643 -12.200930 402 1552 1553 + 1552 H -11.268643 -8.984584 -12.345854 403 1551 + 1553 H -10.432002 -10.035760 -11.529786 403 1551 + 1554 O -26.380108 15.118882 -9.622008 402 1555 1556 + 1555 H -25.930871 15.887042 -9.924512 403 1554 + 1556 H -25.979073 14.306361 -10.084998 403 1554 + 1557 O 1.139515 -19.714505 -8.279716 402 1558 1559 + 1558 H 0.675447 -19.100241 -8.876686 403 1557 + 1559 H 1.861101 -19.991496 -8.757935 403 1557 + 1560 O 17.452914 16.822171 9.920464 402 1561 1562 + 1561 H 17.934078 17.151660 9.199989 403 1560 + 1562 H 17.980199 16.103548 10.329451 403 1560 + 1563 O 18.740004 -12.107924 14.391777 402 1564 1565 + 1564 H 19.596584 -12.274465 14.867937 403 1563 + 1565 H 18.902733 -12.244474 13.491103 403 1563 + 1566 O -15.579375 6.511760 13.017065 402 1567 1568 + 1567 H -15.193219 7.321701 12.610540 403 1566 + 1568 H -15.093538 5.769586 12.622079 403 1566 + 1569 O -0.877815 -3.636485 14.316002 402 1570 1571 + 1570 H -1.480812 -3.188883 14.944590 403 1569 + 1571 H -1.224311 -3.235271 13.526942 403 1569 + 1572 O 7.516564 -9.888221 20.928138 402 1573 1574 + 1573 H 7.083616 -9.984725 20.119275 403 1572 + 1574 H 7.035439 -10.492537 21.460270 403 1572 + 1575 O 26.972175 15.513650 13.835965 402 1576 1577 + 1576 H 27.290530 14.677325 14.220401 403 1575 + 1577 H 26.022826 15.628989 13.956832 403 1575 + 1578 O 18.373056 16.436866 -9.784173 402 1579 1580 + 1579 H 18.173740 16.705423 -10.702898 403 1578 + 1580 H 19.003590 17.095921 -9.494087 403 1578 + 1581 O -2.499599 -10.235115 -18.681799 402 1582 1583 + 1582 H -2.484635 -9.679910 -17.855014 403 1581 + 1583 H -1.762196 -9.952193 -19.147621 403 1581 + 1584 O 2.170631 9.696760 -13.707491 402 1585 1586 + 1585 H 2.410831 10.573952 -14.022044 403 1584 + 1586 H 1.366528 9.911718 -13.203660 403 1584 + 1587 O -22.060495 0.084333 -19.330968 402 1588 1589 + 1588 H -21.759145 -0.801023 -19.628154 403 1587 + 1589 H -21.345397 0.598803 -18.978005 403 1587 + 1590 O 20.717073 -0.364667 -3.266977 402 1591 1592 + 1591 H 20.064258 -0.869174 -2.840894 403 1590 + 1592 H 20.978768 -0.863225 -4.123117 403 1590 + 1593 O -11.693545 -17.585832 12.155919 402 1594 1595 + 1594 H -11.693581 -16.618165 12.297539 403 1593 + 1595 H -10.965597 -17.630843 11.482629 403 1593 + 1596 O 22.033287 -5.610818 11.814279 402 1597 1598 + 1597 H 21.603774 -4.969289 11.213082 403 1596 + 1598 H 22.863855 -5.854126 11.399621 403 1596 + 1599 O -4.245364 20.530679 -11.580108 402 1600 1601 + 1600 H -4.613077 20.058542 -10.812152 403 1599 + 1601 H -4.869612 21.297733 -11.750599 403 1599 + 1602 O 20.837886 3.849343 18.187160 402 1603 1604 + 1603 H 21.637221 4.154388 17.767478 403 1602 + 1604 H 20.753725 4.316852 19.044680 403 1602 + 1605 O 4.000998 20.642070 6.993614 402 1606 1607 + 1606 H 3.097228 20.600441 6.539412 403 1605 + 1607 H 4.007858 20.203528 7.895914 403 1605 + 1608 O 11.947977 15.441293 -0.469120 402 1609 1610 + 1609 H 11.971275 14.454085 -0.273912 403 1608 + 1610 H 12.470807 15.488877 -1.291943 403 1608 + 1611 O 3.007637 18.543541 -2.984774 402 1612 1613 + 1612 H 3.565232 17.725540 -3.038270 403 1611 + 1613 H 2.929337 18.913789 -3.837866 403 1611 + 1614 O 8.597796 -3.024177 11.307241 402 1615 1616 + 1615 H 9.440361 -2.907621 10.794269 403 1614 + 1616 H 8.194484 -3.777321 10.948431 403 1614 + 1617 O 12.969092 -7.932168 -3.416690 402 1618 1619 + 1618 H 12.657272 -8.671538 -3.962914 403 1617 + 1619 H 13.930699 -7.927015 -3.644128 403 1617 + 1620 O 4.690692 11.990242 6.047085 402 1621 1622 + 1621 H 3.830915 11.620745 5.794047 403 1620 + 1622 H 5.366958 11.770788 5.369987 403 1620 + 1623 O 10.838100 15.915400 -16.690449 402 1624 1625 + 1624 H 11.719066 16.216650 -16.583824 403 1623 + 1625 H 10.351788 16.668150 -17.062399 403 1623 + 1626 O 20.760419 3.237669 6.554876 402 1627 1628 + 1627 H 20.210628 2.565167 6.189576 403 1626 + 1628 H 20.243367 4.047032 6.450547 403 1626 + 1629 O -7.351853 -2.751166 -10.694739 402 1630 1631 + 1630 H -8.277520 -2.829710 -11.023595 403 1629 + 1631 H -6.973902 -2.027001 -11.286243 403 1629 + 1632 O 8.338680 -14.152925 -14.216839 402 1633 1634 + 1633 H 7.907963 -14.913791 -13.766433 403 1632 + 1634 H 9.057618 -14.554948 -14.672432 403 1632 + 1635 O -21.745003 -1.600080 -8.484704 402 1636 1637 + 1636 H -22.396276 -0.906185 -8.690601 403 1635 + 1637 H -21.042086 -1.417961 -9.157366 403 1635 + 1638 O 24.505779 -7.277316 -14.651231 402 1639 1640 + 1639 H 24.835649 -6.369110 -14.893362 403 1638 + 1640 H 24.135101 -7.595011 -15.516575 403 1638 + 1641 O 13.325591 -5.149951 -6.169737 402 1642 1643 + 1642 H 14.291969 -5.289577 -6.041288 403 1641 + 1643 H 12.813376 -5.844865 -5.785812 403 1641 + 1644 O -20.933242 20.161591 -8.696079 402 1645 1646 + 1645 H -20.088965 20.396502 -9.157616 403 1644 + 1646 H -21.417399 20.940524 -8.320759 403 1644 + 1647 O 22.832947 -8.348413 -10.288572 402 1648 1649 + 1648 H 23.575495 -7.724229 -10.313126 403 1647 + 1649 H 23.029160 -9.044226 -9.677546 403 1647 + 1650 O 23.743445 2.427859 19.849750 402 1651 1652 + 1651 H 24.532045 1.907225 19.711678 403 1650 + 1652 H 23.062926 1.994077 19.368217 403 1650 + 1653 O 10.589993 1.639740 20.516878 402 1654 1655 + 1654 H 9.987052 1.032362 20.047348 403 1653 + 1655 H 10.624644 2.472330 20.027640 403 1653 + 1656 O 6.500815 -17.047237 7.812429 402 1657 1658 + 1657 H 7.407059 -16.956263 7.440866 403 1656 + 1658 H 6.013508 -17.774059 7.384568 403 1656 + 1659 O -0.199269 -9.380208 -16.449921 402 1660 1661 + 1660 H -0.920685 -8.715985 -16.515053 403 1659 + 1661 H 0.387469 -9.304809 -17.255371 403 1659 + 1662 O 6.245654 20.180381 -12.940075 402 1663 1664 + 1663 H 5.376160 20.220616 -13.392701 403 1662 + 1664 H 6.857081 19.702851 -13.499407 403 1662 + 1665 O -4.928957 -20.301289 11.340442 402 1666 1667 + 1666 H -4.017513 -20.158995 11.049259 403 1665 + 1667 H -4.923799 -20.953195 11.990322 403 1665 + 1668 O -11.515851 -8.388468 19.647979 402 1669 1670 + 1669 H -11.184791 -8.359618 20.524675 403 1668 + 1670 H -12.443923 -8.327763 19.606292 403 1668 + 1671 O -24.167509 7.194575 -0.837148 402 1672 1673 + 1672 H -24.972654 7.649920 -1.275517 403 1671 + 1673 H -24.204709 7.474688 0.131591 403 1671 + 1674 O 12.126351 -16.062203 11.096539 402 1675 1676 + 1675 H 11.280449 -15.927172 10.574646 403 1674 + 1676 H 12.611089 -15.288570 10.879908 403 1674 + 1677 O -7.169287 5.827131 17.736258 402 1678 1679 + 1678 H -6.956548 5.152949 17.035326 403 1677 + 1679 H -6.291387 6.127541 18.098754 403 1677 + 1680 O -19.820265 12.907447 16.581358 402 1681 1682 + 1681 H -19.659011 12.980070 17.534136 403 1680 + 1682 H -20.478433 13.648938 16.483830 403 1680 + 1683 O 10.474631 10.634400 -7.924386 402 1684 1685 + 1684 H 10.794363 11.386619 -7.409132 403 1683 + 1685 H 9.591861 10.377005 -7.560987 403 1683 + 1686 O 9.869765 7.468088 9.667232 402 1687 1688 + 1687 H 9.072542 8.000794 9.695304 403 1686 + 1688 H 10.102662 7.299293 8.720054 403 1686 + 1689 O 11.149756 9.562904 -12.765396 402 1690 1691 + 1690 H 10.686250 9.267978 -11.959062 403 1689 + 1691 H 11.324858 8.766817 -13.298380 403 1689 + 1692 O -8.591767 12.757143 -4.012695 402 1693 1694 + 1693 H -8.324896 13.003317 -4.932948 403 1692 + 1694 H -8.147829 13.384049 -3.416515 403 1692 + 1695 O 4.774504 19.024876 15.999665 402 1696 1697 + 1696 H 4.160294 19.017277 16.757162 403 1695 + 1697 H 5.517925 18.569472 16.400595 403 1695 + 1698 O -4.714429 -2.091345 19.353537 402 1699 1700 + 1699 H -4.854280 -2.828837 19.971329 403 1698 + 1700 H -5.535288 -2.163222 18.793806 403 1698 + 1701 O 3.570216 -18.611817 -15.598378 402 1702 1703 + 1702 H 3.046765 -18.582990 -16.425866 403 1701 + 1703 H 3.158896 -17.918154 -15.032600 403 1701 + 1704 O -11.657691 18.235653 20.509864 402 1705 1706 + 1705 H -12.226759 18.986315 20.717707 403 1704 + 1706 H -11.080397 18.121952 21.271087 403 1704 + 1707 O 14.493937 -0.382813 19.719393 402 1708 1709 + 1708 H 13.979118 -0.142020 20.470391 403 1707 + 1709 H 15.349953 -0.432678 20.118874 403 1707 + 1710 O -25.714868 -12.047610 -14.994953 402 1711 1712 + 1711 H -25.527994 -12.236118 -16.000515 403 1710 + 1712 H -24.876261 -11.553460 -14.748410 403 1710 + 1713 O 6.325847 -15.764455 11.544131 402 1714 1715 + 1714 H 6.229128 -16.154079 12.417251 403 1713 + 1715 H 6.886521 -15.002890 11.743125 403 1713 + 1716 O -27.331883 9.233246 15.237568 402 1717 1718 + 1717 H -26.599380 9.867873 14.994627 403 1716 + 1718 H -27.264332 8.495991 14.623286 403 1716 + 1719 O -25.207375 -3.847132 17.095096 402 1720 1721 + 1720 H -25.445321 -4.629286 16.543803 403 1719 + 1721 H -25.823438 -3.158780 16.776808 403 1719 + 1722 O -2.766266 -13.179260 4.266317 402 1723 1724 + 1723 H -1.896026 -13.215786 3.757612 403 1722 + 1724 H -3.151612 -14.038152 4.175240 403 1722 + 1725 O 17.165111 16.676060 6.100929 402 1726 1727 + 1726 H 17.064451 17.522432 6.606579 403 1725 + 1727 H 16.942925 15.940574 6.655125 403 1725 + 1728 O -18.331646 7.552754 -8.484008 402 1729 1730 + 1729 H -18.933791 7.004225 -7.919061 403 1728 + 1730 H -18.900890 7.785944 -9.196075 403 1728 + 1731 O 26.169311 3.132717 9.584634 402 1732 1733 + 1732 H 26.518912 3.613350 10.302634 403 1731 + 1733 H 25.680453 2.435972 9.901377 403 1731 + 1734 O 1.192323 17.107553 -8.736586 402 1735 1736 + 1735 H 1.021901 17.797734 -9.422544 403 1734 + 1736 H 0.892750 17.475660 -7.885822 403 1734 + 1737 O -25.815030 10.180500 5.376868 402 1738 1739 + 1738 H -26.459337 10.344257 6.080597 403 1737 + 1739 H -25.337134 9.352614 5.563562 403 1737 + 1740 O 9.219642 -20.775000 0.193729 402 1741 1742 + 1741 H 9.939354 -21.194791 -0.335512 403 1740 + 1742 H 8.458200 -21.122557 -0.245347 403 1740 + 1743 O 7.419149 -15.012981 -7.052183 402 1744 1745 + 1744 H 7.072086 -14.800593 -6.138570 403 1743 + 1745 H 6.878848 -15.717530 -7.366638 403 1743 + 1746 O 18.623745 10.156288 3.028217 402 1747 1748 + 1747 H 17.982257 9.440233 2.875628 403 1746 + 1748 H 18.009023 10.975494 3.182536 403 1746 + 1749 O 13.145546 -20.676260 -16.694649 402 1750 1751 + 1750 H 12.815312 -20.227755 -17.488442 403 1749 + 1751 H 12.786182 -21.555938 -16.737351 403 1749 + 1752 O 4.910310 -17.490236 -1.378014 402 1753 1754 + 1753 H 5.657779 -17.456107 -0.820623 403 1752 + 1754 H 5.268563 -17.934730 -2.200934 403 1752 + 1755 O -0.270185 6.286195 9.930733 402 1756 1757 + 1756 H -0.856415 6.001917 10.611025 403 1755 + 1757 H 0.005563 7.171058 10.176397 403 1755 + 1758 O -3.229650 16.643646 19.387659 402 1759 1760 + 1759 H -3.312058 16.163949 18.538257 403 1758 + 1760 H -2.782251 17.481594 19.257422 403 1758 + 1761 O -16.368157 2.960013 13.098824 402 1762 1763 + 1762 H -16.360100 3.430962 13.984851 403 1761 + 1763 H -16.773065 3.567928 12.508334 403 1761 + 1764 O 19.447080 -6.209321 9.611666 402 1765 1766 + 1765 H 18.833539 -5.622887 9.193795 403 1764 + 1766 H 18.949525 -6.526265 10.384214 403 1764 + 1767 O -8.044280 -4.288816 -16.207882 402 1768 1769 + 1768 H -7.966109 -3.883769 -17.074640 403 1767 + 1769 H -7.261903 -4.793399 -15.982149 403 1767 + 1770 O 20.024947 17.270827 14.758218 402 1771 1772 + 1771 H 19.172341 17.478642 15.170634 403 1770 + 1772 H 20.700921 17.006922 15.403538 403 1770 + 1773 O 24.735763 -12.617736 3.782055 402 1774 1775 + 1774 H 24.742238 -13.518522 3.370896 403 1773 + 1775 H 25.350602 -12.232493 3.147824 403 1773 + 1776 O 3.431414 8.925671 6.826679 402 1777 1778 + 1777 H 3.084862 8.827163 7.759644 403 1776 + 1778 H 4.424412 9.107829 6.895448 403 1776 + 1779 O 17.489102 -11.319977 19.702626 402 1780 1781 + 1780 H 18.434347 -11.550903 19.419885 403 1779 + 1781 H 16.965653 -12.122535 19.583109 403 1779 + 1782 O 13.274816 16.183286 -2.849704 402 1783 1784 + 1783 H 13.777976 16.949053 -2.573649 403 1782 + 1784 H 12.549844 16.546466 -3.345363 403 1782 + 1785 O 23.841910 -13.944818 11.597095 402 1786 1787 + 1786 H 23.043336 -14.386099 11.958056 403 1785 + 1787 H 23.668687 -13.015455 11.845078 403 1785 + 1788 O 14.458157 -17.498951 -20.684884 402 1789 1790 + 1789 H 13.916318 -16.687121 -20.523929 403 1788 + 1790 H 14.348004 -17.977683 -19.850686 403 1788 + 1791 O -8.369104 15.140447 -19.622301 402 1792 1793 + 1792 H -9.156426 14.702367 -19.949175 403 1791 + 1793 H -7.765440 15.416867 -20.299390 403 1791 + 1794 O 19.145293 -12.193056 11.874609 402 1795 1796 + 1795 H 18.766654 -11.373734 11.579591 403 1794 + 1796 H 18.521350 -12.726230 11.327543 403 1794 + 1797 O -18.076775 18.801612 -14.295021 402 1798 1799 + 1798 H -18.586562 18.486836 -15.063616 403 1797 + 1799 H -18.385853 18.166574 -13.559441 403 1797 + 1800 O -19.106085 17.513715 -16.406412 402 1801 1802 + 1801 H -18.423458 17.909352 -17.009956 403 1800 + 1802 H -19.076533 16.547362 -16.469991 403 1800 + 1803 O 8.044684 -0.011875 -10.373353 402 1804 1805 + 1804 H 8.668860 -0.626009 -9.915411 403 1803 + 1805 H 8.602268 0.704634 -10.757756 403 1803 + 1806 O -23.287552 -7.074362 17.929889 402 1807 1808 + 1807 H -22.370365 -7.411352 17.793085 403 1806 + 1808 H -23.082861 -6.243551 18.339191 403 1806 + 1809 O 22.099315 -0.856463 5.137385 402 1810 1811 + 1810 H 22.143526 -1.231806 5.942781 403 1809 + 1811 H 22.809699 -1.264756 4.609180 403 1809 + 1812 O 11.618777 5.171830 -12.366225 402 1813 1814 + 1813 H 12.078170 4.347700 -12.198463 403 1812 + 1814 H 10.837551 5.069580 -11.726531 403 1812 + 1815 O 13.014153 9.452672 -20.836207 402 1816 1817 + 1816 H 13.647981 9.913017 -20.352836 403 1815 + 1817 H 13.495084 8.718233 -21.270254 403 1815 + 1818 O 12.425877 4.164162 0.171584 402 1819 1820 + 1819 H 12.703840 3.756309 0.988868 403 1818 + 1820 H 12.991444 5.029213 0.073462 403 1818 + 1821 O -9.835180 14.629378 -13.804396 402 1822 1823 + 1822 H -9.610077 14.944151 -14.684564 403 1821 + 1823 H -8.989021 14.154277 -13.615953 403 1821 + 1824 O -2.408060 19.252237 0.880939 402 1825 1826 + 1825 H -2.493340 19.315730 -0.074698 403 1824 + 1826 H -2.255762 20.125803 1.185504 403 1824 + 1827 O 0.176360 18.576859 -11.340843 402 1828 1829 + 1828 H 0.973470 18.653833 -11.875634 403 1827 + 1829 H -0.251936 19.428753 -11.234458 403 1827 + 1830 O 17.647376 -13.725079 1.965824 402 1831 1832 + 1831 H 17.003636 -13.021631 1.726278 403 1830 + 1832 H 17.566508 -13.822114 2.932054 403 1830 + 1833 O 22.517860 -11.753774 5.019726 402 1834 1835 + 1834 H 23.053003 -11.763573 4.218425 403 1833 + 1835 H 22.141706 -12.627432 4.996598 403 1833 + 1836 O 11.399220 8.806142 17.642468 402 1837 1838 + 1837 H 12.004399 8.181799 18.040253 403 1836 + 1838 H 12.065291 9.442856 17.324430 403 1836 + 1839 O -22.707547 3.590100 -15.076457 402 1840 1841 + 1840 H -23.015628 3.384474 -15.944834 403 1839 + 1841 H -22.136913 4.410365 -15.213029 403 1839 + 1842 O 26.828338 -4.765161 15.663973 402 1843 1844 + 1843 H 26.832047 -4.257803 16.501858 403 1842 + 1844 H 26.708016 -5.703070 15.737740 403 1842 + 1845 O 22.946626 3.404021 -19.628978 402 1846 1847 + 1846 H 23.362608 3.005393 -20.435220 403 1845 + 1847 H 23.702005 3.678843 -19.069388 403 1845 + 1848 O 14.618693 -13.688118 5.201099 402 1849 1850 + 1849 H 14.145978 -13.778387 4.371412 403 1848 + 1850 H 14.286294 -12.904817 5.661369 403 1848 + 1851 O 20.255504 -4.724409 16.548573 402 1852 1853 + 1852 H 21.059576 -4.438221 16.144026 403 1851 + 1853 H 20.147655 -4.094495 17.295647 403 1851 + 1854 O 17.946944 -13.347081 -18.020931 402 1855 1856 + 1855 H 18.795624 -13.646112 -18.426334 403 1854 + 1856 H 17.332163 -14.081728 -18.189230 403 1854 + 1857 O -21.344615 -17.675607 -16.681902 402 1858 1859 + 1858 H -21.267118 -18.651712 -16.747948 403 1857 + 1859 H -21.006193 -17.563628 -15.786919 403 1857 + 1860 O 9.992481 17.630547 2.228887 402 1861 1862 + 1861 H 10.766809 17.530717 1.634799 403 1860 + 1862 H 9.806200 16.754569 2.642189 403 1860 + 1863 O 24.337802 -5.112482 8.921340 402 1864 1865 + 1864 H 24.079827 -4.328771 8.467115 403 1863 + 1865 H 24.773308 -4.851600 9.745303 403 1863 + 1866 O 14.392943 4.303039 -14.169804 402 1867 1868 + 1867 H 15.354569 4.444986 -14.451391 403 1866 + 1868 H 13.827235 4.378323 -14.920116 403 1866 + 1869 O 13.209648 -16.451396 -6.580199 402 1870 1871 + 1870 H 13.147603 -16.683269 -5.631990 403 1869 + 1871 H 12.554494 -16.916090 -7.141613 403 1869 + 1872 O -11.258451 -8.728449 -17.504889 402 1873 1874 + 1873 H -10.630935 -8.841887 -16.742169 403 1872 + 1874 H -10.880429 -7.995350 -17.987253 403 1872 + 1875 O 6.970091 -11.502288 7.137693 402 1876 1877 + 1876 H 6.712825 -11.950891 7.959605 403 1875 + 1877 H 6.204207 -11.628119 6.619766 403 1875 + 1878 O -10.553038 -2.495546 -20.126478 402 1879 1880 + 1879 H -11.112035 -2.806841 -20.861108 403 1878 + 1880 H -10.112026 -1.746092 -20.545249 403 1878 + 1881 O 1.164804 16.447528 -16.932229 402 1882 1883 + 1882 H 1.075245 17.028648 -17.728070 403 1881 + 1883 H 0.434843 16.567725 -16.272167 403 1881 + 1884 O 8.169876 -8.073942 10.663670 402 1885 1886 + 1885 H 8.495588 -8.362155 9.831946 403 1884 + 1886 H 7.357988 -8.507192 10.922724 403 1884 + 1887 O -9.618401 15.869865 -1.419048 402 1888 1889 + 1888 H -10.476694 15.771852 -1.849867 403 1887 + 1889 H -9.747028 16.624761 -0.845144 403 1887 + 1890 O -16.212359 4.292450 15.905633 402 1891 1892 + 1891 H -15.313397 4.006789 16.095169 403 1890 + 1892 H -16.439629 4.732906 16.740073 403 1890 + 1893 O 21.084596 9.207592 -17.940912 402 1894 1895 + 1894 H 20.944531 8.655711 -18.738875 403 1893 + 1895 H 20.567153 10.036337 -17.965821 403 1893 + 1896 O 6.469383 -5.770861 20.006921 402 1897 1898 + 1897 H 5.993567 -6.597617 19.829705 403 1896 + 1898 H 7.305198 -6.017049 20.409842 403 1896 + 1899 O 17.758755 -18.446472 11.244435 402 1900 1901 + 1900 H 16.943206 -18.055205 11.026410 403 1899 + 1901 H 17.620974 -18.589448 12.216673 403 1899 + 1902 O 2.239377 -2.639523 -18.372832 402 1903 1904 + 1903 H 2.961435 -2.802836 -17.698014 403 1902 + 1904 H 2.575925 -2.857520 -19.307575 403 1902 + 1905 O 21.718884 10.313541 3.085849 402 1906 1907 + 1906 H 21.842990 10.122072 2.194243 403 1905 + 1907 H 20.773441 10.408461 3.286860 403 1905 + 1908 O 13.337112 -4.261456 -15.095198 402 1909 1910 + 1909 H 12.794211 -4.900007 -14.644470 403 1908 + 1910 H 14.199509 -4.728814 -15.315507 403 1908 + 1911 O -9.310962 9.865254 8.826714 402 1912 1913 + 1912 H -9.669554 9.579689 7.984792 403 1911 + 1913 H -9.735207 9.276237 9.445171 403 1911 + 1914 O -15.178299 -9.566992 -12.324180 402 1915 1916 + 1915 H -15.367699 -10.462879 -12.630414 403 1914 + 1916 H -14.646062 -9.588613 -11.528432 403 1914 + 1917 O -15.859885 -9.750776 8.964734 402 1918 1919 + 1918 H -15.304809 -9.850444 8.125201 403 1917 + 1919 H -16.789316 -9.705790 8.757985 403 1917 + 1920 O -25.239908 11.310293 -1.569623 402 1921 1922 + 1921 H -25.920791 10.663431 -1.377427 403 1920 + 1922 H -24.373594 10.784234 -1.594237 403 1920 + 1923 O 24.834518 19.880125 -12.068838 402 1924 1925 + 1924 H 24.902598 19.037821 -11.641999 403 1923 + 1925 H 24.569359 20.529336 -11.363034 403 1923 + 1926 O -4.910084 -12.441089 2.868321 402 1927 1928 + 1927 H -4.196304 -12.571833 3.512128 403 1926 + 1928 H -4.472778 -12.489053 1.987214 403 1926 + 1929 O 26.315754 13.248691 -3.958358 402 1930 1931 + 1930 H 27.266655 13.212107 -4.180929 403 1929 + 1931 H 26.465406 13.335958 -3.028348 403 1929 + 1932 O 24.328527 13.817013 16.149181 402 1933 1934 + 1933 H 24.827781 14.030624 16.932358 403 1932 + 1934 H 24.179636 14.591188 15.603219 403 1932 + 1935 O 21.962373 -16.827624 8.004516 402 1936 1937 + 1936 H 22.598048 -16.206072 7.580939 403 1935 + 1937 H 22.450590 -17.261823 8.740917 403 1935 + 1938 O -4.825363 -16.614974 -12.877741 402 1939 1940 + 1939 H -4.014790 -16.722031 -13.388018 403 1938 + 1940 H -4.509200 -15.980807 -12.256351 403 1938 + 1941 O 23.185997 6.818710 7.631707 402 1942 1943 + 1942 H 24.005009 7.366044 7.817913 403 1941 + 1943 H 22.474898 7.499325 7.506791 403 1941 + 1944 O 6.937383 5.850956 20.832797 402 1945 1946 + 1945 H 7.490164 6.651357 20.679338 403 1944 + 1946 H 6.435673 5.734889 20.013467 403 1944 + 1947 O 25.402656 -2.159701 -17.957744 402 1948 1949 + 1948 H 25.621496 -3.084064 -17.880786 403 1947 + 1949 H 25.529344 -1.860574 -18.911595 403 1947 + 1950 O 10.846509 -11.228008 2.120758 402 1951 1952 + 1951 H 9.913338 -11.028888 2.277705 403 1950 + 1952 H 11.049198 -10.691152 1.384887 403 1950 + 1953 O 23.084559 -1.383675 -1.852278 402 1954 1955 + 1954 H 23.773226 -1.138388 -2.498419 403 1953 + 1955 H 22.268498 -0.905061 -2.136333 403 1953 + 1956 O -25.783789 -13.543097 -4.342707 402 1957 1958 + 1957 H -26.780798 -13.463014 -4.533505 403 1956 + 1958 H -25.653740 -14.383466 -3.955333 403 1956 + 1959 O 1.861632 12.171063 18.076482 402 1960 1961 + 1960 H 2.556591 11.916600 18.652688 403 1959 + 1961 H 1.260792 12.537866 18.715290 403 1959 + 1962 O -19.142537 14.105154 8.572032 402 1963 1964 + 1963 H -19.793181 13.415150 8.631452 403 1962 + 1964 H -19.398536 14.384324 7.672644 403 1962 + 1965 O 9.479353 -2.096525 -4.320850 402 1966 1967 + 1966 H 10.426570 -2.240688 -4.643403 403 1965 + 1967 H 9.264888 -1.350839 -4.888316 403 1965 + 1968 O 3.551422 -11.576062 19.271265 402 1969 1970 + 1969 H 4.336383 -11.005500 19.220941 403 1968 + 1970 H 3.612389 -12.122719 20.093542 403 1968 + 1971 O -18.654239 -9.535541 17.560019 402 1972 1973 + 1972 H -17.877715 -9.179943 17.854976 403 1971 + 1973 H -18.494513 -10.119241 16.820922 403 1971 + 1974 O 22.066324 -17.399278 -0.499821 402 1975 1976 + 1975 H 21.820234 -16.674838 0.099599 403 1974 + 1976 H 21.433067 -17.360481 -1.209273 403 1974 + 1977 O -9.234082 15.614627 11.653381 402 1978 1979 + 1978 H -8.328429 15.947628 11.735875 403 1977 + 1979 H -9.156328 14.657428 11.604942 403 1977 + 1980 O 22.367726 20.360775 16.024793 402 1981 1982 + 1981 H 21.845316 20.438168 16.820627 403 1980 + 1982 H 23.011426 21.038841 16.155608 403 1980 + 1983 O 25.827187 -16.169219 18.903921 402 1984 1985 + 1984 H 25.252638 -15.420311 18.639632 403 1983 + 1985 H 25.326971 -16.554629 19.621305 403 1983 + 1986 O -19.668270 -7.707320 -8.620499 402 1987 1988 + 1987 H -19.491830 -6.794820 -8.636334 403 1986 + 1988 H -20.495353 -7.784914 -8.110009 403 1986 + 1989 O -15.712732 17.116061 17.387342 402 1990 1991 + 1990 H -14.998205 17.679818 17.573935 403 1989 + 1991 H -16.301994 17.627283 16.828989 403 1989 + 1992 O 0.390078 14.938221 -20.122911 402 1993 1994 + 1993 H -0.551277 14.873494 -20.329275 403 1992 + 1994 H 0.539841 14.256395 -19.453229 403 1992 + 1995 O 15.977716 -18.683555 17.772786 402 1996 1997 + 1996 H 15.456606 -18.921580 16.979089 403 1995 + 1997 H 16.280568 -17.751033 17.661557 403 1995 + 1998 O 5.239306 11.123091 17.557541 402 1999 2000 + 1999 H 4.918202 10.242467 17.653834 403 1998 + 2000 H 6.086403 10.952070 18.021365 403 1998 + 2001 O 9.328850 -5.185156 13.272163 402 2002 2003 + 2002 H 9.601653 -6.131901 13.229534 403 2001 + 2003 H 9.762360 -4.740121 12.531719 403 2001 + 2004 O 25.477790 -8.345165 0.584885 402 2005 2006 + 2005 H 25.598427 -7.389198 0.879361 403 2004 + 2006 H 26.086040 -8.798249 1.118095 403 2004 + 2007 O 17.311830 -17.527015 -10.578123 402 2008 2009 + 2008 H 17.719447 -16.732289 -10.965110 403 2007 + 2009 H 16.654082 -17.252150 -9.925765 403 2007 + 2010 O -4.429164 -9.201790 -14.116626 402 2011 2012 + 2011 H -4.244658 -8.992311 -13.212737 403 2010 + 2012 H -5.336375 -8.936542 -14.234036 403 2010 + 2013 O 2.267339 -4.673980 16.117302 402 2014 2015 + 2014 H 3.232259 -4.591281 16.113612 403 2013 + 2015 H 1.900019 -4.413838 16.958419 403 2013 + 2016 O 25.781004 -8.714690 8.400591 402 2017 2018 + 2017 H 24.912042 -8.751175 8.867313 403 2016 + 2018 H 25.752072 -9.508607 7.845086 403 2016 + 2019 O 24.780338 7.832712 -16.490027 402 2020 2021 + 2020 H 25.553470 8.297242 -16.909830 403 2019 + 2021 H 24.349053 7.422109 -17.205903 403 2019 + 2022 O -10.973211 -14.579748 -20.349565 402 2023 2024 + 2023 H -11.809581 -14.181319 -20.199526 403 2022 + 2024 H -11.271798 -15.372634 -20.833354 403 2022 + 2025 O 20.831402 -9.834964 6.727716 402 2026 2027 + 2026 H 21.613032 -10.442134 6.754402 403 2025 + 2027 H 20.647604 -9.731183 7.657599 403 2025 + 2028 O 0.619789 -15.810628 3.994148 402 2029 2030 + 2029 H 0.887335 -16.417198 3.309856 403 2028 + 2030 H 1.249715 -15.910162 4.713083 403 2028 + 2031 O 23.689965 0.227417 -19.055575 402 2032 2033 + 2032 H 23.390627 1.115135 -18.834814 403 2031 + 2033 H 24.618115 0.214091 -18.686279 403 2031 + 2034 O -19.356143 -14.966182 6.464534 402 2035 2036 + 2035 H -18.731353 -14.875616 7.195912 403 2034 + 2036 H -19.299498 -14.034705 6.108709 403 2034 + 2037 O -4.810820 7.093213 18.692708 402 2038 2039 + 2038 H -4.214506 7.397678 17.991691 403 2037 + 2039 H -5.304442 7.897279 18.897729 403 2037 + 2040 O 12.472494 14.825856 12.199392 402 2041 2042 + 2041 H 11.666376 14.488038 12.655650 403 2040 + 2042 H 12.151762 15.361991 11.488854 403 2040 + 2043 O -2.525590 -19.553036 -5.583420 402 2044 2045 + 2044 H -3.387077 -20.012041 -5.603558 403 2043 + 2045 H -1.916602 -19.904101 -6.266561 403 2043 + 2046 O -13.215935 11.484331 -2.785220 402 2047 2048 + 2047 H -12.887174 11.682417 -1.972234 403 2046 + 2048 H -12.509591 11.786661 -3.422263 403 2046 + 2049 O 13.801640 -19.398163 -2.800474 402 2050 2051 + 2050 H 12.819741 -19.619737 -2.646754 403 2049 + 2051 H 13.897982 -19.592042 -3.772199 403 2049 + 2052 O -26.233001 19.527836 -20.067788 402 2053 2054 + 2053 H -25.451886 18.897692 -20.194468 403 2052 + 2054 H -26.399315 19.934622 -20.917526 403 2052 + 2055 O 8.349896 -20.273103 -5.512912 402 2056 2057 + 2056 H 8.674030 -19.375363 -5.549945 403 2055 + 2057 H 7.700037 -20.342277 -4.787842 403 2055 + 2058 O -15.037355 -17.935516 15.211469 402 2059 2060 + 2059 H -14.146082 -18.339695 15.389947 403 2058 + 2060 H -15.202223 -17.984699 14.215392 403 2058 + 2061 O 8.152699 -3.220333 -19.381684 402 2062 2063 + 2062 H 7.762730 -2.473688 -19.830286 403 2061 + 2063 H 8.435795 -2.793242 -18.522747 403 2061 + 2064 O 10.849575 20.172811 -12.945894 402 2065 2066 + 2065 H 9.989543 19.760584 -12.890237 403 2064 + 2066 H 10.974253 20.477018 -13.831243 403 2064 + 2067 O -18.094216 -18.088456 -0.091619 402 2068 2069 + 2068 H -17.380813 -18.647373 0.106032 403 2067 + 2069 H -18.936664 -18.511988 -0.052421 403 2067 + 2070 O 23.784383 -1.234714 -8.545459 402 2071 2072 + 2071 H 23.004694 -0.954068 -8.088149 403 2070 + 2072 H 23.886388 -2.202962 -8.397824 403 2070 + 2073 O 4.670856 19.296845 -6.507264 402 2074 2075 + 2074 H 5.525567 19.132893 -6.020467 403 2073 + 2075 H 4.474979 18.536310 -7.056492 403 2073 + 2076 O 9.453183 -16.128245 10.894262 402 2077 2078 + 2077 H 9.172486 -17.052303 10.804233 403 2076 + 2078 H 8.694890 -15.636054 10.554101 403 2076 + 2079 O 27.285633 -19.419687 13.608447 402 2080 2081 + 2080 H 27.147712 -20.155434 14.224268 403 2079 + 2081 H 27.432376 -19.841205 12.735609 403 2079 + 2082 O -13.953143 18.767914 -18.628277 402 2083 2084 + 2083 H -14.509541 18.177509 -19.151919 403 2082 + 2084 H -14.459773 19.481659 -18.276757 403 2082 + 2085 O -8.503297 -13.558947 20.139036 402 2086 2087 + 2086 H -9.241112 -13.897460 20.705789 403 2085 + 2087 H -7.777412 -13.533354 20.859006 403 2085 + 2088 O 14.842167 15.398345 -11.842827 402 2089 2090 + 2089 H 14.711447 15.430309 -12.769279 403 2088 + 2090 H 14.422321 14.556870 -11.583006 403 2088 + 2091 O 23.515535 -17.148566 -6.707313 402 2092 2093 + 2092 H 22.824916 -16.517939 -6.421660 403 2091 + 2093 H 24.263955 -17.052636 -6.082683 403 2091 + 2094 O 19.904467 -17.703379 -13.473161 402 2095 2096 + 2095 H 20.119864 -16.820025 -13.921272 403 2094 + 2096 H 18.948028 -17.662123 -13.295016 403 2094 + 2097 O -9.019729 7.630624 20.233912 402 2098 2099 + 2098 H -8.958585 7.872806 21.205680 403 2097 + 2099 H -8.777610 8.395080 19.734355 403 2097 + 2100 O -16.953402 12.468570 8.282984 402 2101 2102 + 2101 H -17.680339 13.160784 8.478943 403 2100 + 2102 H -17.500933 11.923064 7.633961 403 2100 + 2103 O -8.054795 18.180983 8.459840 402 2104 2105 + 2104 H -8.807469 17.559774 8.499933 403 2103 + 2105 H -7.598916 17.959389 7.659706 403 2103 + 2106 O 10.859202 13.972660 9.371520 402 2107 2108 + 2107 H 10.330904 14.662590 8.917941 403 2106 + 2108 H 11.760678 13.901317 8.995461 403 2106 + 2109 O -20.599796 5.434907 14.082586 402 2110 2111 + 2110 H -19.823357 5.807091 13.669543 403 2109 + 2111 H -20.650272 4.587948 13.614754 403 2109 + 2112 O 0.190160 0.223418 -18.957409 402 2113 2114 + 2113 H 0.213080 -0.260216 -19.803123 403 2112 + 2114 H -0.108015 1.088627 -19.162666 403 2112 + 2115 O -14.055059 -11.353804 -4.019394 402 2116 2117 + 2116 H -14.940567 -11.063742 -3.674139 403 2115 + 2117 H -13.870222 -12.125592 -3.430663 403 2115 + 2118 O 16.635849 17.308753 12.681784 402 2119 2120 + 2119 H 16.261670 16.470264 12.423079 403 2118 + 2120 H 17.008841 17.677123 11.849363 403 2118 + 2121 O -25.308969 5.432856 -17.149527 402 2122 2123 + 2122 H -24.655164 5.918154 -17.671798 403 2121 + 2123 H -24.982451 5.555957 -16.246756 403 2121 + 2124 O -5.099798 0.287541 -14.704188 402 2125 2126 + 2125 H -5.138931 0.519591 -15.635776 403 2124 + 2126 H -4.195405 -0.084328 -14.624163 403 2124 + 2127 O -23.748764 -10.173408 15.212702 402 2128 2129 + 2128 H -23.345980 -11.023651 15.356645 403 2127 + 2129 H -22.994745 -9.539993 15.112815 403 2127 + 2130 O -19.199669 -17.758897 16.946421 402 2131 2132 + 2131 H -19.316903 -16.926776 16.445483 403 2130 + 2132 H -18.281115 -18.078783 16.752689 403 2130 + 2133 O 24.275104 4.639677 -5.172613 402 2134 2135 + 2134 H 24.760810 5.226861 -4.613774 403 2133 + 2135 H 24.701632 4.684738 -6.052735 403 2133 + 2136 O 17.563599 12.903092 3.658695 402 2137 2138 + 2137 H 17.685848 13.560550 2.940588 403 2136 + 2138 H 16.898391 13.306778 4.183635 403 2136 + 2139 O 4.174461 14.293392 18.270873 402 2140 2141 + 2140 H 4.252009 13.308189 18.184247 403 2139 + 2141 H 3.284820 14.507614 18.560426 403 2139 + 2142 O 19.179266 -5.054347 -19.519249 402 2143 2144 + 2143 H 18.780260 -5.604062 -18.845970 403 2142 + 2144 H 19.534147 -5.684633 -20.141388 403 2142 + 2145 O 15.658994 11.957779 13.199900 402 2146 2147 + 2146 H 15.623319 12.838749 12.752640 403 2145 + 2147 H 16.531973 11.890366 13.660327 403 2145 + 2148 O 24.758272 -19.997077 5.366209 402 2149 2150 + 2149 H 24.975628 -20.215262 6.282332 403 2148 + 2150 H 23.761106 -19.988430 5.431807 403 2148 + 2151 O -2.249027 18.570837 -6.683241 402 2152 2153 + 2152 H -2.430859 18.100958 -7.499568 403 2151 + 2153 H -2.994327 18.644727 -6.092295 403 2151 + 2154 O 3.560378 -14.631233 -16.617924 402 2155 2156 + 2155 H 3.964695 -14.691511 -15.761000 403 2154 + 2156 H 3.979389 -13.913756 -17.067597 403 2154 + 2157 O -20.545154 -8.912553 -11.230039 402 2158 2159 + 2158 H -21.471069 -9.085454 -11.070560 403 2157 + 2159 H -20.109583 -8.288894 -10.586743 403 2157 + 2160 O -19.728929 -18.157363 9.832477 402 2161 2162 + 2161 H -20.527618 -17.995705 9.320962 403 2160 + 2162 H -19.366046 -18.994557 9.552804 403 2160 + 2163 O -12.565736 15.723300 8.977635 402 2164 2165 + 2164 H -13.331978 15.327968 8.600724 403 2163 + 2165 H -12.885953 15.953376 9.855856 403 2163 + 2166 O 7.768656 -13.056656 -8.955241 402 2167 2168 + 2167 H 8.048624 -13.789739 -8.425150 403 2166 + 2168 H 8.500788 -12.860524 -9.542256 403 2166 + 2169 O 17.695317 -0.658526 -5.443674 402 2170 2171 + 2170 H 16.888949 -0.180431 -5.230393 403 2169 + 2171 H 17.868907 -0.568768 -6.336008 403 2169 + 2172 O -26.474265 -17.668366 15.551800 402 2173 2174 + 2173 H -25.973432 -16.911585 15.255881 403 2172 + 2174 H -26.867392 -18.124201 14.764520 403 2172 + 2175 O 20.955024 16.299890 1.156790 402 2176 2177 + 2176 H 20.921523 15.384753 1.335509 403 2175 + 2177 H 20.079452 16.568627 1.085050 403 2175 + 2178 O -23.821616 -1.174086 5.308601 402 2179 2180 + 2179 H -24.669920 -1.473611 4.967755 403 2178 + 2180 H -23.878862 -0.261519 5.469448 403 2178 + 2181 O -25.063965 -17.135593 -5.451522 402 2182 2183 + 2182 H -24.564833 -16.443850 -5.938694 403 2181 + 2183 H -25.016214 -17.933665 -5.953179 403 2181 + 2184 O 8.668628 -10.867057 3.901078 402 2185 2186 + 2185 H 7.746163 -11.110803 3.959883 403 2184 + 2186 H 8.752868 -10.022287 4.307352 403 2184 + 2187 O 5.527084 -9.208555 11.411321 402 2188 2189 + 2188 H 4.725607 -8.751662 11.714973 403 2187 + 2189 H 5.164735 -10.130404 11.316322 403 2187 + 2190 O -9.337532 -6.457757 20.443267 402 2191 2192 + 2191 H -9.836709 -6.506988 19.607051 403 2190 + 2192 H -8.808476 -7.295450 20.450087 403 2190 + 2193 O 19.513522 2.780765 9.780761 402 2194 2195 + 2194 H 19.329574 3.702885 9.602934 403 2193 + 2195 H 18.756331 2.266956 9.355945 403 2193 + 2196 O -0.037870 9.082570 10.914997 402 2197 2198 + 2197 H -0.144923 8.896093 11.865591 403 2196 + 2198 H 0.659909 9.734037 10.785946 403 2196 + 2199 O 21.027998 -15.348739 14.790857 402 2200 2201 + 2200 H 21.254465 -15.801776 13.888722 403 2199 + 2201 H 20.075738 -15.400354 14.845656 403 2199 + 2202 O 14.156515 -11.391327 -14.361896 402 2203 2204 + 2203 H 14.547773 -11.645291 -13.478079 403 2202 + 2204 H 14.944302 -11.067054 -14.899771 403 2202 + 2205 O -25.175320 17.336673 -10.823444 402 2206 2207 + 2206 H -24.334636 17.464575 -11.235937 403 2205 + 2207 H -25.742033 18.106292 -10.995823 403 2205 + 2208 O -4.110604 17.298456 -14.084863 402 2209 2210 + 2209 H -5.063030 17.631527 -14.014860 403 2208 + 2210 H -3.534872 17.849349 -13.549744 403 2208 + 2211 O -8.725501 -4.824788 13.985429 402 2212 2213 + 2212 H -8.885224 -4.493817 14.844915 403 2211 + 2213 H -9.307957 -4.341036 13.364528 403 2211 + 2214 O -16.804142 -4.642352 -8.769233 402 2215 2216 + 2215 H -16.450670 -4.499749 -7.869595 403 2214 + 2216 H -16.368056 -3.963859 -9.273107 403 2214 + 2217 O -13.154274 13.347332 -10.792162 402 2218 2219 + 2218 H -13.404917 13.942330 -10.034598 403 2217 + 2219 H -12.589084 12.641097 -10.473229 403 2217 + 2220 O -8.087285 12.645852 17.838668 402 2221 2222 + 2221 H -8.371003 13.597239 17.804934 403 2220 + 2222 H -8.469236 12.290110 16.988633 403 2220 + 2223 O -22.931798 10.095495 10.652715 402 2224 2225 + 2224 H -23.213802 9.766315 11.531742 403 2223 + 2225 H -23.320207 11.046413 10.700380 403 2223 + 2226 O -20.983751 11.377312 6.751864 402 2227 2228 + 2227 H -21.503099 10.599928 6.692621 403 2226 + 2228 H -21.162587 11.703483 7.660694 403 2226 + 2229 O -9.661190 -11.046578 19.483449 402 2230 2231 + 2230 H -9.724620 -11.203957 20.428241 403 2229 + 2231 H -9.182029 -11.809683 19.119545 403 2229 + 2232 O 20.353500 0.575918 7.152755 402 2233 2234 + 2233 H 20.303576 0.620770 8.117649 403 2232 + 2234 H 20.337320 -0.339163 6.903512 403 2232 + 2235 O 15.990143 -2.457675 4.143017 402 2236 2237 + 2236 H 15.489807 -1.953955 3.480334 403 2235 + 2237 H 15.653499 -2.040453 4.954556 403 2235 + 2238 O -2.567783 16.482281 -16.807948 402 2239 2240 + 2239 H -3.050946 16.892783 -16.078496 403 2238 + 2240 H -2.535318 17.087619 -17.572948 403 2238 + 2241 O -16.459463 12.994478 3.247220 402 2242 2243 + 2242 H -16.263104 13.723100 3.963882 403 2241 + 2243 H -16.915538 12.273221 3.618885 403 2241 + 2244 O -19.849611 -12.213163 -10.741659 402 2245 2246 + 2245 H -19.664050 -11.750480 -11.517833 403 2244 + 2246 H -20.220973 -11.559473 -10.070660 403 2244 + 2247 O 9.529408 -8.147204 4.860752 402 2248 2249 + 2248 H 9.247691 -7.588893 5.626073 403 2247 + 2249 H 10.362750 -8.519549 5.100951 403 2247 + 2250 O 21.538384 -19.843213 20.537686 402 2251 2252 + 2251 H 20.838857 -19.226662 20.298246 403 2250 + 2252 H 21.322950 -20.195215 21.445033 403 2250 + 2253 O -17.414751 11.192172 -0.613866 402 2254 2255 + 2254 H -16.961551 11.804357 -1.153593 403 2253 + 2255 H -16.725569 10.585952 -0.366735 403 2253 + 2256 O -21.091905 1.428060 -3.164120 402 2257 2258 + 2257 H -21.397983 0.608166 -3.585164 403 2256 + 2258 H -21.036566 1.285518 -2.209763 403 2256 + 2259 O 4.570809 -15.227797 -13.905090 402 2260 2261 + 2260 H 5.091400 -16.090349 -13.835376 403 2259 + 2261 H 4.857834 -14.567263 -13.304845 403 2259 + 2262 O 10.258640 0.903759 11.623534 402 2263 2264 + 2263 H 10.598017 1.120991 12.514742 403 2262 + 2264 H 10.521679 1.552470 11.006853 403 2262 + 2265 O 17.642778 19.808652 2.346246 402 2266 2267 + 2266 H 17.869355 20.445525 1.653123 403 2265 + 2267 H 18.518553 19.467904 2.662406 403 2265 + 2268 O -22.563090 -16.244370 16.474521 402 2269 2270 + 2269 H -22.037402 -15.816362 17.175370 403 2268 + 2270 H -22.163193 -17.008155 16.111897 403 2268 + 2271 O -21.737447 10.632642 0.323883 402 2272 2273 + 2272 H -22.138870 9.972645 -0.310600 403 2271 + 2273 H -20.878663 10.242561 0.662313 403 2271 + 2274 O 4.943953 4.514136 10.142833 402 2275 2276 + 2275 H 4.093975 4.955485 10.181030 403 2274 + 2276 H 5.290181 4.560969 11.077254 403 2274 + 2277 O 27.098096 16.972617 9.553607 402 2278 2279 + 2278 H 27.164532 17.549674 10.320006 403 2277 + 2279 H 26.222145 17.230319 9.158216 403 2277 + 2280 O 9.975471 10.519219 19.375075 402 2281 2282 + 2281 H 10.438521 9.921274 18.809666 403 2280 + 2282 H 10.113621 10.195006 20.328269 403 2280 + 2283 O 19.572560 8.531305 -14.059063 402 2284 2285 + 2284 H 20.062311 8.733262 -13.213496 403 2283 + 2285 H 20.153062 7.889577 -14.538183 403 2283 + 2286 O -7.918488 -2.954663 -18.780336 402 2287 2288 + 2287 H -7.314540 -2.910798 -19.514402 403 2286 + 2288 H -8.797924 -3.116600 -19.166228 403 2286 + 2289 O 19.686374 -16.545236 11.269807 402 2290 2291 + 2290 H 18.989129 -17.260241 11.377153 403 2289 + 2291 H 19.219253 -15.710481 11.534976 403 2289 + 2292 O 27.391573 13.462198 15.739536 402 2293 2294 + 2293 H 26.622656 13.814429 16.131734 403 2292 + 2294 H 28.086271 13.184682 16.372753 403 2292 + 2295 O 18.671829 14.132646 1.432787 402 2296 2297 + 2296 H 18.377115 15.035385 1.296775 403 2295 + 2297 H 19.190360 13.851325 0.615983 403 2295 + 2298 O -12.681771 -19.875375 -9.428073 402 2299 2300 + 2299 H -12.883609 -20.344329 -8.608964 403 2298 + 2300 H -13.567320 -19.451635 -9.646126 403 2298 + 2301 O 10.029899 9.448526 2.506329 402 2302 2303 + 2302 H 9.228082 9.803143 2.872633 403 2301 + 2303 H 10.370666 8.711255 3.072050 403 2301 + 2304 O 6.829895 1.451627 -19.901465 402 2305 2306 + 2305 H 5.933644 1.521889 -20.328666 403 2304 + 2306 H 6.997933 0.508973 -20.108952 403 2304 + 2307 O 11.280235 -14.880225 18.973288 402 2308 2309 + 2308 H 11.853282 -14.806884 19.759711 403 2307 + 2309 H 11.206610 -13.922929 18.647648 403 2307 + 2310 O -13.509311 20.508361 -14.696662 402 2311 2312 + 2311 H -13.366236 21.153458 -13.979706 403 2310 + 2312 H -13.642549 19.724179 -14.192639 403 2310 + 2313 O 15.445671 -17.794973 -8.479139 402 2314 2315 + 2314 H 14.669400 -17.783629 -7.901271 403 2313 + 2315 H 15.605108 -18.746647 -8.547881 403 2313 + 2316 O -18.852558 16.377330 10.008262 402 2317 2318 + 2317 H -18.954566 15.472318 9.697097 403 2316 + 2318 H -18.836824 16.305839 10.975588 403 2316 + 2319 O -3.265075 16.259228 2.098989 402 2320 2321 + 2320 H -3.687496 16.647682 2.840607 403 2319 + 2321 H -3.231168 15.327934 2.400445 403 2319 + 2322 O 23.408970 8.557256 -2.138126 402 2323 2324 + 2323 H 23.726381 8.828223 -3.046334 403 2322 + 2324 H 24.153951 8.006209 -1.806696 403 2322 + 2325 O -18.228938 -7.461297 -20.804424 402 2326 2327 + 2326 H -17.795687 -7.325321 -21.656583 403 2325 + 2327 H -19.188295 -7.558977 -20.991723 403 2325 + 2328 O 14.146043 8.886880 -14.615085 402 2329 2330 + 2329 H 13.553393 8.171127 -14.600739 403 2328 + 2330 H 15.003303 8.599303 -14.311172 403 2328 + 2331 O 20.665164 -4.419654 -16.715421 402 2332 2333 + 2332 H 20.745422 -5.254288 -17.245683 403 2331 + 2333 H 20.538188 -3.785743 -17.440686 403 2331 + 2334 O -26.165001 -17.430791 -11.871737 402 2335 2336 + 2335 H -26.769662 -17.569088 -12.614295 403 2334 + 2336 H -25.372303 -17.816712 -12.251152 403 2334 + 2337 O 8.380243 12.002311 -18.225092 402 2338 2339 + 2338 H 9.331509 12.039099 -17.900481 403 2337 + 2339 H 7.935426 11.441291 -17.531137 403 2337 + 2340 O 16.095732 -15.248679 -18.961804 402 2341 2342 + 2341 H 16.404115 -16.023436 -19.441838 403 2340 + 2342 H 15.279718 -15.501183 -18.509138 403 2340 + 2343 O 22.345963 -0.521889 9.487232 402 2344 2345 + 2344 H 22.570555 0.299269 9.062706 403 2343 + 2345 H 21.500534 -0.394595 9.878388 403 2343 + 2346 O -5.612444 19.185073 -9.536350 402 2347 2348 + 2347 H -5.038468 18.530538 -9.043403 403 2346 + 2348 H -6.014867 19.664271 -8.828529 403 2346 + 2349 O -25.317965 -13.476019 -10.680751 402 2350 2351 + 2350 H -24.422815 -13.795959 -10.857483 403 2349 + 2351 H -25.587407 -14.286723 -10.139795 403 2349 + 2352 O 5.097575 -2.791870 -18.340648 402 2353 2354 + 2353 H 5.426002 -3.124971 -17.421700 403 2352 + 2354 H 5.173769 -1.845992 -18.214725 403 2352 + 2355 O -12.050426 13.594034 -0.308748 402 2356 2357 + 2356 H -12.143354 14.332220 -0.865135 403 2355 + 2357 H -12.835416 13.379684 0.170780 403 2355 + 2358 O 21.220086 12.431770 7.373850 402 2359 2360 + 2359 H 20.289621 12.356271 7.355050 403 2358 + 2360 H 21.528409 11.600369 6.969319 403 2358 + 2361 O -11.849558 -15.011079 -4.217755 402 2362 2363 + 2362 H -12.535045 -15.564610 -4.601476 403 2361 + 2363 H -11.261594 -15.726054 -3.732481 403 2361 + 2364 O 19.540600 10.648547 -0.222993 402 2365 2366 + 2365 H 19.073765 10.676651 0.596923 403 2364 + 2366 H 19.853650 11.516176 -0.351029 403 2364 + 2367 O -1.367659 10.060973 3.255905 402 2368 2369 + 2368 H -0.787645 10.846481 3.221548 403 2367 + 2369 H -0.921325 9.404127 2.683633 403 2367 + 2370 O 17.574245 20.192556 -13.486878 402 2371 2372 + 2371 H 18.041333 19.630746 -14.072375 403 2370 + 2372 H 18.127340 20.293838 -12.705179 403 2370 + 2373 O -18.105957 7.325844 1.685035 402 2374 2375 + 2374 H -17.284929 7.597738 2.015915 403 2373 + 2375 H -18.515197 8.193099 1.440712 403 2373 + 2376 O -25.771851 -0.494052 1.833459 402 2377 2378 + 2377 H -26.562791 0.014660 2.156519 403 2376 + 2378 H -25.800109 -0.615443 0.880744 403 2376 + 2379 O 13.515684 3.091718 8.129575 402 2380 2381 + 2380 H 12.824035 3.780462 8.011639 403 2379 + 2381 H 13.855067 3.149101 9.026041 403 2379 + 2382 O 15.024255 -12.331971 18.507086 402 2383 2384 + 2383 H 14.688886 -12.986046 17.868523 403 2382 + 2384 H 14.285850 -11.759175 18.796860 403 2382 + 2385 O 10.503062 -17.208661 -17.537094 402 2386 2387 + 2386 H 10.869560 -17.224545 -18.470986 403 2385 + 2387 H 10.144441 -18.040582 -17.343990 403 2385 + 2388 O 2.330431 13.849933 -16.758821 402 2389 2390 + 2389 H 1.519885 13.548197 -17.169816 403 2388 + 2390 H 2.257199 14.793756 -16.760513 403 2388 + 2391 O -23.129172 -9.148548 -12.092521 402 2392 2393 + 2392 H -24.075243 -8.995756 -12.000743 403 2391 + 2393 H -23.086180 -10.039746 -12.445685 403 2391 + 2394 O -17.448662 -1.079141 -7.931513 402 2395 2396 + 2395 H -17.738453 -1.885709 -7.374659 403 2394 + 2396 H -18.172042 -1.099635 -8.625421 403 2394 + 2397 O 24.048570 -3.763661 -7.564125 402 2398 2399 + 2398 H 24.193240 -3.884883 -6.642519 403 2397 + 2399 H 24.456227 -4.566888 -7.925689 403 2397 + 2400 O -17.808703 -19.337398 7.373130 402 2401 2402 + 2401 H -17.303175 -20.173651 7.501985 403 2400 + 2402 H -17.692612 -19.135904 6.461238 403 2400 + 2403 O 4.319079 -18.666468 -6.315988 402 2404 2405 + 2404 H 4.318654 -19.531271 -6.749054 403 2403 + 2405 H 3.377567 -18.420225 -6.140192 403 2403 + 2406 O 15.744362 14.892988 2.660633 402 2407 2408 + 2407 H 15.944482 15.856708 2.714939 403 2406 + 2408 H 15.301384 14.836913 1.848608 403 2406 + 2409 O -6.829329 -18.727707 2.030136 402 2410 2411 + 2410 H -6.415578 -18.452019 2.842593 403 2409 + 2411 H -6.067476 -19.005491 1.466821 403 2409 + 2412 O 24.121188 19.977112 -20.354495 402 2413 2414 + 2413 H 24.224055 19.319758 -19.652345 403 2412 + 2414 H 24.762727 19.635175 -20.939363 403 2412 + 2415 O 10.579259 -12.534608 5.151755 402 2416 2417 + 2416 H 9.930043 -12.025918 4.646940 403 2415 + 2417 H 11.359927 -12.071097 4.861131 403 2415 + 2418 O 5.967673 -14.216687 -10.676351 402 2419 2420 + 2419 H 6.631855 -14.774737 -11.170158 403 2418 + 2420 H 6.490580 -13.637897 -10.118514 403 2418 + 2421 O 18.539687 -16.102929 15.331204 402 2422 2423 + 2422 H 18.327655 -16.200138 16.203787 403 2421 + 2423 H 17.897003 -15.568195 14.864351 403 2421 + 2424 O -2.895055 -4.676531 11.113797 402 2425 2426 + 2425 H -2.434824 -5.435723 10.710060 403 2424 + 2426 H -2.231401 -4.035506 11.395814 403 2424 + 2427 O -8.133832 14.629593 7.309404 402 2428 2429 + 2428 H -8.851831 15.090624 7.871798 403 2427 + 2429 H -7.946895 13.906109 7.942402 403 2427 + 2430 O 22.250798 0.698906 -0.231699 402 2431 2432 + 2431 H 22.200775 1.664146 -0.197509 403 2430 + 2432 H 22.955911 0.389699 -0.887067 403 2430 + 2433 O 4.057613 14.734523 9.271521 402 2434 2435 + 2434 H 3.560432 15.591515 9.153949 403 2433 + 2435 H 4.938114 14.882755 8.921185 403 2433 + 2436 O -17.698257 12.666615 -4.894250 402 2437 2438 + 2437 H -17.252884 12.676027 -4.012690 403 2436 + 2438 H -18.619276 12.371224 -4.622833 403 2436 + 2439 O 26.668158 -12.819700 -1.311515 402 2440 2441 + 2440 H 27.032009 -13.646800 -1.097954 403 2439 + 2441 H 26.646890 -12.850693 -2.254784 403 2439 + 2442 O 7.224554 13.850996 3.318452 402 2443 2444 + 2443 H 8.019795 14.275937 3.600876 403 2442 + 2444 H 7.668540 12.980654 3.041459 403 2442 + 2445 O 8.952709 -7.047293 -13.075849 402 2446 2447 + 2446 H 9.898167 -6.904505 -13.302591 403 2445 + 2447 H 8.562667 -6.214154 -12.992709 403 2445 + 2448 O -17.814401 -1.840934 -1.803929 402 2449 2450 + 2449 H -18.744975 -1.741200 -1.902642 403 2448 + 2450 H -17.699335 -2.395812 -1.018915 403 2448 + 2451 O -24.621095 6.164997 -14.673611 402 2452 2453 + 2452 H -24.877382 5.755063 -13.785112 403 2451 + 2453 H -23.950276 6.830635 -14.339769 403 2451 + 2454 O 10.479140 -19.025039 18.297194 402 2455 2456 + 2455 H 11.349364 -18.876899 18.653004 403 2454 + 2456 H 10.644550 -19.606803 17.504887 403 2454 + 2457 O -19.101403 14.252398 -1.786055 402 2458 2459 + 2458 H -19.573879 14.657593 -2.525389 403 2457 + 2459 H -19.587903 13.601901 -1.323620 403 2457 + 2460 O 6.717226 1.088539 17.700070 402 2461 2462 + 2461 H 6.231555 1.199419 18.516697 403 2460 + 2462 H 6.881490 0.099135 17.787770 403 2460 + 2463 O -13.643189 -7.863866 -8.730575 402 2464 2465 + 2464 H -14.517866 -7.638837 -9.023604 403 2463 + 2465 H -13.154332 -7.346815 -9.390510 403 2463 + 2466 O -17.730487 0.990816 -0.622980 402 2467 2468 + 2467 H -17.303015 0.205330 -0.935730 403 2466 + 2468 H -17.531444 1.017418 0.308170 403 2466 + 2469 O 25.260176 -10.957318 6.206094 402 2470 2471 + 2470 H 25.876991 -10.477352 5.676397 403 2469 + 2471 H 24.475935 -10.963099 5.603334 403 2469 + 2472 O 14.205628 -17.408033 -13.601399 402 2473 2474 + 2473 H 14.188193 -18.247713 -13.204445 403 2472 + 2474 H 13.713279 -17.625825 -14.405922 403 2472 + 2475 O -20.784853 -15.686238 -5.898849 402 2476 2477 + 2476 H -19.875611 -15.547599 -5.727799 403 2475 + 2477 H -21.245430 -14.929289 -5.375604 403 2475 + 2478 O -22.633197 8.330983 -13.909999 402 2479 2480 + 2479 H -22.233520 9.245054 -13.847024 403 2478 + 2480 H -21.843881 7.942242 -14.256165 403 2478 + 2481 O 11.786714 0.286536 -14.937634 402 2482 2483 + 2482 H 11.786532 -0.671475 -15.215390 403 2481 + 2483 H 11.605445 0.272418 -13.981805 403 2481 + 2484 O 1.681240 0.254113 10.330852 402 2485 2486 + 2485 H 1.597166 -0.618385 10.733271 403 2484 + 2486 H 1.413887 0.849687 11.007136 403 2484 + 2487 O 6.751727 13.837704 8.238736 402 2488 2489 + 2488 H 6.439245 13.979946 7.299037 403 2487 + 2489 H 7.165300 14.697405 8.431164 403 2487 + 2490 O 22.234756 20.556412 6.164713 402 2491 2492 + 2491 H 21.672715 21.351790 6.258812 403 2490 + 2492 H 21.702890 19.818097 6.555926 403 2490 + 2493 O 17.385018 20.449668 10.876882 402 2494 2495 + 2494 H 16.551469 20.156010 10.407413 403 2493 + 2495 H 17.440995 21.384757 10.538556 403 2493 + 2496 O 17.700641 4.527370 19.573010 402 2497 2498 + 2497 H 17.031995 4.431285 20.256942 403 2496 + 2498 H 17.481318 3.724034 19.023628 403 2496 + 2499 O 0.483339 18.111382 -1.823860 402 2500 2501 + 2500 H 0.218803 18.655109 -1.106869 403 2499 + 2501 H 1.294713 18.496788 -2.211913 403 2499 + 2502 O 22.943918 -17.096855 -14.079609 402 2503 2504 + 2503 H 22.830905 -16.325512 -14.742916 403 2502 + 2504 H 22.793828 -16.695124 -13.249381 403 2502 + 2505 O -12.197414 -2.755310 -15.143763 402 2506 2507 + 2506 H -11.972492 -3.409760 -15.785801 403 2505 + 2507 H -11.687560 -1.995802 -15.449188 403 2505 + 2508 O 26.233813 3.059744 -20.109192 402 2509 2510 + 2509 H 25.634066 3.752709 -19.758728 403 2508 + 2510 H 26.841050 3.505495 -20.746283 403 2508 + 2511 O -0.398685 9.886291 -12.320899 402 2512 2513 + 2512 H -0.971500 9.110158 -12.271110 403 2511 + 2513 H -0.140227 10.055684 -11.384852 403 2511 + 2514 O 24.766172 -8.159537 20.532359 402 2515 2516 + 2515 H 24.676407 -7.239089 20.840721 403 2514 + 2516 H 23.932220 -8.459730 20.138818 403 2514 + 2517 O -13.286555 16.304911 0.900630 402 2518 2519 + 2518 H -13.716595 15.953327 1.640887 403 2517 + 2519 H -12.366691 16.365858 1.124146 403 2517 + 2520 O 23.399832 -13.989313 -14.426821 402 2521 2522 + 2521 H 22.828210 -13.569339 -13.765880 403 2520 + 2522 H 23.255649 -13.414985 -15.246789 403 2520 + 2523 O -22.204092 -4.611638 18.736383 402 2524 2525 + 2524 H -21.249902 -4.938147 18.770328 403 2523 + 2525 H -22.211606 -3.716829 18.428273 403 2523 + 2526 O 21.224851 -14.221140 4.789172 402 2527 2528 + 2527 H 20.596044 -14.495409 5.464993 403 2526 + 2528 H 21.036876 -14.781346 3.969428 403 2526 + 2529 O -0.044311 17.960476 1.830489 402 2530 2531 + 2530 H -0.313520 17.147157 1.446425 403 2529 + 2531 H -0.796207 18.542831 1.866711 403 2529 + 2532 O -18.246500 10.701990 6.592891 402 2533 2534 + 2533 H -19.216406 10.992455 6.669125 403 2532 + 2534 H -18.267435 9.771442 6.876019 403 2532 + 2535 O -0.694143 4.494214 14.021020 402 2536 2537 + 2536 H -1.277964 4.997681 13.392435 403 2535 + 2537 H -1.155981 4.663647 14.857205 403 2535 + 2538 O 22.107052 12.819546 -9.903327 402 2539 2540 + 2539 H 21.296704 13.306649 -9.951121 403 2538 + 2540 H 22.688713 13.295428 -10.537192 403 2538 + 2541 O 15.302055 -5.253465 4.034438 402 2542 2543 + 2542 H 15.326181 -4.291521 3.882146 403 2541 + 2543 H 16.042293 -5.540500 3.526531 403 2541 + 2544 O 23.950953 1.271229 5.710913 402 2545 2546 + 2545 H 23.173495 0.716989 5.765239 403 2544 + 2546 H 24.051944 1.770274 6.552925 403 2544 + 2547 O 14.279151 12.647971 15.806599 402 2548 2549 + 2548 H 14.591090 12.573140 14.893038 403 2547 + 2549 H 13.381765 12.300162 15.960467 403 2547 + 2550 O 15.038801 -1.661905 6.589100 402 2551 2552 + 2551 H 15.892587 -1.551660 6.975739 403 2550 + 2552 H 14.462182 -0.875051 6.734929 403 2550 + 2553 O -6.429505 -9.279231 12.087220 402 2554 2555 + 2554 H -6.701830 -10.093703 11.622225 403 2553 + 2555 H -5.612815 -9.032770 11.586921 403 2553 + 2556 O 11.290924 -10.372276 7.217133 402 2557 2558 + 2557 H 10.622389 -10.955150 6.788259 403 2556 + 2558 H 11.616275 -9.796597 6.503882 403 2556 + 2559 O -24.866907 -13.913179 10.222650 402 2560 2561 + 2560 H -24.271979 -13.182736 9.950447 403 2559 + 2561 H -25.017302 -14.420326 9.408453 403 2559 + 2562 O -27.314146 -19.793576 17.380891 402 2563 2564 + 2563 H -27.699149 -20.386657 16.714229 403 2562 + 2564 H -26.959051 -19.085769 16.826343 403 2562 + 2565 O 12.965414 4.595141 18.162499 402 2566 2567 + 2566 H 13.458928 3.797998 18.472673 403 2565 + 2567 H 12.462784 4.369395 17.349650 403 2565 + 2568 O 19.720286 6.716538 19.074363 402 2569 2570 + 2569 H 18.977040 6.161032 19.255447 403 2568 + 2570 H 20.199596 6.784088 19.921433 403 2568 + 2571 O -17.837323 -10.531279 11.466891 402 2572 2573 + 2572 H -18.443320 -10.286485 12.180075 403 2571 + 2573 H -17.136906 -10.892709 12.057832 403 2571 + 2574 O 3.118617 16.201513 -14.560896 402 2575 2576 + 2575 H 2.524275 15.456086 -14.261283 403 2574 + 2576 H 3.153477 16.211998 -15.545130 403 2574 + 2577 O 15.713269 9.977240 -3.550942 402 2578 2579 + 2578 H 16.125798 10.839790 -3.855082 403 2577 + 2579 H 16.256998 9.663172 -2.774134 403 2577 + 2580 O 13.404328 14.288352 8.236302 402 2581 2582 + 2581 H 13.804031 15.222512 8.339581 403 2580 + 2582 H 14.094703 13.583706 8.316160 403 2580 + 2583 O 1.715242 -17.595877 -5.517990 402 2584 2585 + 2584 H 1.864739 -16.803207 -5.011472 403 2583 + 2585 H 1.121502 -17.292257 -6.152942 403 2583 + 2586 O 11.186181 -15.378074 -8.941210 402 2587 2588 + 2587 H 10.964916 -15.109818 -9.814041 403 2586 + 2588 H 11.164732 -14.643976 -8.304569 403 2586 + 2589 O -25.412651 0.765668 -5.618949 402 2590 2591 + 2590 H -25.840497 0.596705 -6.434188 403 2589 + 2591 H -26.027451 1.074079 -4.940438 403 2589 + 2592 O -11.380143 13.107124 -18.001950 402 2593 2594 + 2593 H -12.159770 13.386797 -17.518060 403 2592 + 2594 H -11.627822 13.258638 -18.958908 403 2592 + 2595 O 7.443094 19.776722 19.670510 402 2596 2597 + 2596 H 6.730151 19.191868 19.918965 403 2595 + 2597 H 7.622698 19.719431 18.722036 403 2595 + 2598 O 24.425946 4.299128 7.836287 402 2599 2600 + 2599 H 24.143986 5.210765 7.985415 403 2598 + 2600 H 24.990386 4.054602 8.572061 403 2598 + 2601 O -3.501704 -11.679155 -10.742632 402 2602 2603 + 2602 H -4.397462 -12.025343 -10.633214 403 2601 + 2603 H -3.405610 -11.663721 -11.695424 403 2601 + 2604 O 0.913373 -18.230470 16.876362 402 2605 2606 + 2605 H 0.053834 -18.577145 16.706546 403 2604 + 2606 H 1.398023 -19.065707 17.119688 403 2604 + 2607 O -9.901596 19.393938 15.691257 402 2608 2609 + 2608 H -9.078500 18.954279 15.490614 403 2607 + 2609 H -10.185869 18.992605 16.470215 403 2607 + 2610 O 17.500333 8.706246 -1.323866 402 2611 2612 + 2611 H 18.176182 9.357546 -1.088149 403 2610 + 2612 H 17.886380 7.895975 -1.087485 403 2610 + 2613 O -24.806806 -14.651049 -14.711674 402 2614 2615 + 2614 H -23.905722 -14.363057 -14.892641 403 2613 + 2615 H -25.324843 -13.797568 -14.671497 403 2613 + 2616 O -11.922848 -15.711273 -13.536344 402 2617 2618 + 2617 H -11.771327 -16.170114 -14.379176 403 2616 + 2618 H -11.859275 -16.406199 -12.902056 403 2616 + 2619 O -27.003017 7.585104 3.060101 402 2620 2621 + 2620 H -26.800446 6.932155 2.407207 403 2619 + 2621 H -26.438815 7.393710 3.843574 403 2619 + 2622 O -10.312090 7.223617 10.185454 402 2623 2624 + 2623 H -10.405406 7.379966 11.161275 403 2622 + 2624 H -9.783333 6.436443 10.181461 403 2622 + 2625 O 23.537015 20.390749 -9.649267 402 2626 2627 + 2626 H 23.323982 21.198505 -9.168669 403 2625 + 2627 H 23.931089 19.837314 -8.973454 403 2625 + 2628 O -17.448795 -20.856696 -12.629322 402 2629 2630 + 2629 H -17.613855 -21.585186 -13.226336 403 2628 + 2630 H -18.268235 -20.483922 -12.239203 403 2628 + 2631 O -5.704053 -12.831319 -13.206852 402 2632 2633 + 2632 H -6.332034 -12.109323 -13.311978 403 2631 + 2633 H -4.837836 -12.573450 -13.575508 403 2631 + 2634 O -7.475606 18.168410 15.238194 402 2635 2636 + 2635 H -6.927022 17.679409 15.798229 403 2634 + 2636 H -6.978971 18.983237 14.964387 403 2634 + 2637 O 23.258739 11.168040 16.596096 402 2638 2639 + 2638 H 23.818087 11.847416 16.270136 403 2637 + 2639 H 23.610710 10.307417 16.344734 403 2637 + 2640 O 3.146606 8.327361 -18.713397 402 2641 2642 + 2641 H 3.334432 7.845623 -19.520851 403 2640 + 2642 H 3.621381 9.175132 -18.785471 403 2640 + 2643 O 0.508878 16.181859 6.176221 402 2644 2645 + 2644 H 1.478661 16.383107 6.127134 403 2643 + 2645 H 0.329178 16.140784 7.185704 403 2643 + 2646 O -11.810390 15.699273 5.840977 402 2647 2648 + 2647 H -12.031355 16.450687 6.361038 403 2646 + 2648 H -10.941390 15.840688 5.470174 403 2646 + 2649 O 16.703781 -6.435675 -7.458235 402 2650 2651 + 2650 H 15.950366 -6.851824 -7.907248 403 2649 + 2651 H 16.319676 -6.119538 -6.579472 403 2649 + 2652 O -16.104630 7.738737 15.683306 402 2653 2654 + 2653 H -15.741449 7.072122 15.101362 403 2652 + 2654 H -15.325944 8.330995 15.966646 403 2652 + 2655 O -12.982372 -5.391773 13.641043 402 2656 2657 + 2656 H -13.067158 -6.334773 13.565642 403 2655 + 2657 H -13.835584 -5.074352 13.303582 403 2655 + 2658 O -0.691433 15.384761 -9.798051 402 2659 2660 + 2659 H 0.035655 15.975465 -9.534555 403 2658 + 2660 H -1.411870 15.925295 -10.115684 403 2658 + 2661 O 22.895397 13.997330 -2.879616 402 2662 2663 + 2662 H 23.276050 14.805518 -2.488993 403 2661 + 2663 H 21.981907 14.160579 -3.026251 403 2661 + 2664 O -6.947442 -13.379975 4.783672 402 2665 2666 + 2665 H -6.469058 -13.127559 4.014561 403 2664 + 2666 H -7.365275 -12.581164 5.147764 403 2664 + 2667 O -6.156966 10.605862 2.666376 402 2668 2669 + 2668 H -6.752949 10.183956 3.255572 403 2667 + 2669 H -5.588229 11.111653 3.195145 403 2667 + 2670 O 17.104300 -12.560553 4.419376 402 2671 2672 + 2671 H 16.344172 -13.086998 4.734928 403 2670 + 2672 H 17.420711 -11.981042 5.141534 403 2670 + 2673 O -27.199948 7.334242 -15.333048 402 2674 2675 + 2674 H -26.297948 6.895160 -15.306746 403 2673 + 2675 H -27.693886 6.547850 -15.268217 403 2673 + 2676 O 18.024202 -19.856328 -19.395594 402 2677 2678 + 2677 H 18.487766 -20.698158 -19.394705 403 2676 + 2678 H 17.496643 -19.929970 -20.262172 403 2676 + 2679 O 22.144036 -16.812143 16.683717 402 2680 2681 + 2680 H 21.875393 -16.308766 15.860916 403 2679 + 2681 H 22.479620 -17.614693 16.338233 403 2679 + 2682 O 25.514687 -13.472113 7.132093 402 2683 2684 + 2683 H 25.319079 -13.294653 8.096235 403 2682 + 2684 H 25.494887 -12.570062 6.821050 403 2682 + 2685 O -12.445347 -17.163112 -18.161764 402 2686 2687 + 2686 H -13.331012 -16.853903 -17.823843 403 2685 + 2687 H -12.475852 -18.105485 -18.058376 403 2685 + 2688 O 6.245110 16.618836 2.470683 402 2689 2690 + 2689 H 5.362728 16.987415 2.415415 403 2688 + 2690 H 6.013984 15.709339 2.583315 403 2688 + 2691 O -7.618060 -8.630004 1.461475 402 2692 2693 + 2692 H -8.009714 -7.788174 1.663581 403 2691 + 2693 H -7.300014 -8.871099 2.309214 403 2691 + 2694 O 1.276161 -5.724890 -17.027124 402 2695 2696 + 2695 H 0.639753 -5.451556 -16.374073 403 2694 + 2696 H 1.572713 -6.534640 -16.615769 403 2694 + 2697 O 20.941259 -12.865847 16.430327 402 2698 2699 + 2698 H 21.406858 -13.389929 15.801253 403 2697 + 2699 H 21.410092 -12.085207 16.695307 403 2697 + 2700 O 18.670123 -9.367430 14.139852 402 2701 2702 + 2701 H 17.803568 -9.004865 14.207764 403 2700 + 2702 H 18.435630 -10.292015 14.355155 403 2700 + 2703 O 15.733761 -0.209804 0.007017 402 2704 2705 + 2704 H 15.513443 -0.802742 -0.762427 403 2703 + 2705 H 15.180436 -0.596633 0.738607 403 2703 + 2706 O 20.535815 18.401459 7.207233 402 2707 2708 + 2707 H 20.172747 18.499555 8.120342 403 2706 + 2708 H 19.715556 18.443909 6.669483 403 2706 + 2709 O -19.654075 2.825062 1.617329 402 2710 2711 + 2710 H -20.035859 3.209607 2.473368 403 2709 + 2711 H -19.137175 3.619122 1.285240 403 2709 + 2712 O -5.984107 19.675136 -16.959798 402 2713 2714 + 2713 H -5.160819 19.281994 -17.190879 403 2712 + 2714 H -5.770973 20.610003 -16.990477 403 2712 + 2715 O 26.042716 7.197405 -0.343564 402 2716 2717 + 2716 H 26.688586 6.461363 -0.227844 403 2715 + 2717 H 25.557638 7.239657 0.456505 403 2715 + 2718 O 22.024763 3.604615 -12.891547 402 2719 2720 + 2719 H 21.193970 3.808969 -13.364435 403 2718 + 2720 H 22.195897 4.401136 -12.384999 403 2718 + 2721 O -27.135160 -9.370585 20.643959 402 2722 2723 + 2722 H -28.030228 -9.176750 20.474699 403 2721 + 2723 H -26.577987 -8.800343 20.128692 403 2721 + 2724 O 8.395602 -17.119113 3.456766 402 2725 2726 + 2725 H 8.859834 -17.667269 2.833722 403 2724 + 2726 H 7.655636 -17.591648 3.745120 403 2724 + 2727 O -24.404359 -0.181200 15.657271 402 2728 2729 + 2728 H -25.038728 0.161741 16.314921 403 2727 + 2729 H -24.896501 -0.279136 14.882179 403 2727 + 2730 O -6.891560 5.632315 -20.701537 402 2731 2732 + 2731 H -7.366523 6.287143 -21.223329 403 2730 + 2732 H -7.630504 5.050659 -20.462604 403 2730 + 2733 O -15.566391 -18.747028 -6.177602 402 2734 2735 + 2734 H -15.142312 -18.219593 -5.559758 403 2733 + 2735 H -16.127679 -19.358388 -5.691405 403 2733 + 2736 O -3.401719 -8.548294 5.789954 402 2737 2738 + 2737 H -3.203950 -7.652649 5.894670 403 2736 + 2738 H -3.475505 -8.723091 4.829013 403 2736 + 2739 O -14.869473 17.641299 -11.130330 402 2740 2741 + 2740 H -15.356466 18.395479 -10.824746 403 2739 + 2741 H -14.164630 17.932079 -11.714816 403 2739 + 2742 O -8.566470 9.810858 18.580750 402 2743 2744 + 2743 H -7.826026 10.409943 18.459685 403 2742 + 2744 H -8.595914 9.242196 17.832030 403 2742 + 2745 O 15.884351 -0.825682 -9.976397 402 2746 2747 + 2746 H 16.580456 -1.202192 -10.550817 403 2745 + 2747 H 16.179129 0.090931 -10.023947 403 2745 + 2748 O -6.440363 -16.182406 14.932475 402 2749 2750 + 2749 H -5.547886 -16.002472 14.729390 403 2748 + 2750 H -6.819275 -16.083044 14.039020 403 2748 + 2751 O -15.767451 -12.920838 -5.752541 402 2752 2753 + 2752 H -14.944068 -12.805684 -5.287481 403 2751 + 2753 H -15.473066 -13.122281 -6.647708 403 2751 + 2754 O -17.665031 -20.836176 14.939409 402 2755 2756 + 2755 H -16.990389 -21.130134 14.286529 403 2754 + 2756 H -18.400170 -20.675073 14.279982 403 2754 + 2757 O -22.492854 -19.049287 15.743348 402 2758 2759 + 2758 H -23.226808 -19.456562 15.249983 403 2757 + 2759 H -22.430818 -19.617870 16.566271 403 2757 + 2760 O 18.577331 8.130140 -4.339187 402 2761 2762 + 2761 H 19.102086 8.936870 -4.101075 403 2760 + 2762 H 17.943090 8.097223 -3.622023 403 2760 + 2763 O -8.059195 -11.528283 11.014399 402 2764 2765 + 2764 H -8.491272 -11.206486 10.183267 403 2763 + 2765 H -7.559001 -12.278215 10.621240 403 2763 + 2766 O -0.354476 13.050972 -11.242317 402 2767 2768 + 2767 H -0.049943 12.197330 -10.889757 403 2766 + 2768 H -0.319360 13.679003 -10.509947 403 2766 + 2769 O -22.692724 -6.768839 -13.959385 402 2770 2771 + 2770 H -22.638060 -6.234744 -13.112330 403 2769 + 2771 H -22.909077 -7.637803 -13.626522 403 2769 + 2772 O 4.453531 -16.513982 -10.118567 402 2773 2774 + 2773 H 5.009279 -17.005000 -9.492769 403 2772 + 2774 H 4.837806 -15.680507 -10.286610 403 2772 + 2775 O -14.211895 -3.759096 -20.057898 402 2776 2777 + 2776 H -14.318355 -2.866044 -19.740155 403 2775 + 2777 H -13.541901 -3.847665 -20.736218 403 2775 + 2778 O 26.693079 9.858450 -14.505848 402 2779 2780 + 2779 H 26.995219 9.161898 -15.033866 403 2778 + 2780 H 25.767285 9.604872 -14.294807 403 2778 + 2781 O -1.593304 -2.461499 11.764930 402 2782 2783 + 2782 H -0.575245 -2.524541 11.545614 403 2781 + 2783 H -1.885036 -1.661756 11.286623 403 2781 + 2784 O -19.660824 -20.494500 2.235869 402 2785 2786 + 2785 H -20.078029 -21.333649 2.487444 403 2784 + 2786 H -19.181632 -20.681107 1.379436 403 2784 + 2787 O 4.144088 17.144901 -7.996934 402 2788 2789 + 2788 H 4.141310 16.441147 -7.303669 403 2787 + 2789 H 3.204041 17.192031 -8.237159 403 2787 + 2790 O 24.148563 16.188551 14.675204 402 2791 2792 + 2791 H 24.234269 17.058984 15.034647 403 2790 + 2792 H 23.773522 16.320292 13.788777 403 2790 + 2793 O -11.859704 2.830217 -15.811214 402 2794 2795 + 2794 H -12.674780 3.212291 -15.481544 403 2793 + 2795 H -11.777095 3.234540 -16.701788 403 2793 + 2796 O -14.309989 12.182667 1.560506 402 2797 2798 + 2797 H -13.393237 12.215837 1.842065 403 2796 + 2798 H -14.715876 12.517376 2.368763 403 2796 + 2799 O -7.611903 8.096548 -15.149217 402 2800 2801 + 2800 H -8.323994 7.679983 -15.518143 403 2799 + 2801 H -6.945506 8.015221 -15.887869 403 2799 + 2802 O -19.095296 -11.187670 -3.400222 402 2803 2804 + 2803 H -19.337682 -11.939672 -2.902754 403 2802 + 2804 H -18.131286 -10.890144 -3.347747 403 2802 + 2805 O -3.684618 -18.692360 -9.413075 402 2806 2807 + 2806 H -3.418979 -17.929749 -9.940845 403 2805 + 2807 H -2.916246 -19.202389 -9.257694 403 2805 + 2808 O -24.383366 4.449647 -2.247488 402 2809 2810 + 2809 H -24.017217 3.645809 -1.897604 403 2808 + 2810 H -24.220917 5.021187 -1.511294 403 2808 + 2811 O -19.731647 -12.211221 2.860739 402 2812 2813 + 2812 H -19.245645 -12.129462 2.005512 403 2811 + 2813 H -20.512036 -12.824760 2.628969 403 2811 + 2814 O -4.683560 -15.770086 9.389938 402 2815 2816 + 2815 H -5.061246 -15.024625 8.860317 403 2814 + 2816 H -5.320477 -16.506457 9.373591 403 2814 + 2817 O -4.887399 -5.093738 -15.497549 402 2818 2819 + 2818 H -5.401164 -5.893295 -15.248311 403 2817 + 2819 H -4.758120 -4.537262 -14.717756 403 2817 + 2820 O -14.685481 -17.958902 -3.365836 402 2821 2822 + 2821 H -14.177516 -17.147605 -3.110889 403 2820 + 2822 H -15.533211 -17.687906 -3.096067 403 2820 + 2823 O 24.950357 10.761179 -11.253927 402 2824 2825 + 2824 H 25.623382 10.724523 -10.501653 403 2823 + 2825 H 24.912589 11.668740 -11.614144 403 2823 + 2826 O 5.896274 1.022377 5.410141 402 2827 2828 + 2827 H 5.144364 0.409378 5.470882 403 2826 + 2828 H 6.702894 0.529043 5.601445 403 2826 + 2829 O -10.707964 -12.538200 -15.636360 402 2830 2831 + 2830 H -11.433886 -12.205371 -16.086670 403 2829 + 2831 H -10.099661 -13.047707 -16.220825 403 2829 + 2832 O 25.311857 10.178415 6.672916 402 2833 2834 + 2833 H 25.652073 11.053667 6.645762 403 2832 + 2834 H 25.462543 9.793786 5.796182 403 2832 + 2835 O 13.351375 -13.843752 2.567223 402 2836 2837 + 2836 H 12.454525 -14.099339 2.561046 403 2835 + 2837 H 13.804123 -14.196570 1.793439 403 2835 + 2838 O 6.447086 -1.674870 18.025371 402 2839 2840 + 2839 H 6.966001 -2.437397 17.753314 403 2838 + 2840 H 5.596824 -1.849843 17.645605 403 2838 + 2841 O -7.195562 13.506129 2.012549 402 2842 2843 + 2842 H -6.788362 12.635839 2.194379 403 2841 + 2843 H -6.577836 13.973475 1.500153 403 2841 + 2844 O 13.594384 20.297397 2.445796 402 2845 2846 + 2845 H 13.788282 19.607477 3.108308 403 2844 + 2846 H 13.006415 19.871282 1.852966 403 2844 + 2847 O 15.233611 0.850818 -5.243920 402 2848 2849 + 2848 H 15.311708 1.467460 -4.483590 403 2847 + 2849 H 15.351381 1.519810 -6.000951 403 2847 + 2850 O -21.392858 -6.660913 15.084747 402 2851 2852 + 2851 H -21.093136 -6.580317 16.005763 403 2850 + 2852 H -20.482050 -6.866879 14.680665 403 2850 + 2853 O 21.798067 9.236981 0.429299 402 2854 2855 + 2854 H 22.425954 9.071754 -0.267587 403 2853 + 2855 H 21.188410 9.810447 0.032847 403 2853 + 2856 O -16.844679 -14.439050 3.033305 402 2857 2858 + 2857 H -17.236824 -14.606294 2.191567 403 2856 + 2858 H -17.149528 -13.681189 3.446869 403 2856 + 2859 O -16.118636 -14.695009 11.770906 402 2860 2861 + 2860 H -16.061462 -15.566570 12.219315 403 2859 + 2861 H -15.401385 -14.815928 11.092232 403 2859 + 2862 O -25.116635 -0.336266 -13.211265 402 2863 2864 + 2863 H -26.034773 -0.593788 -13.205266 403 2862 + 2864 H -25.075870 0.263017 -13.996810 403 2862 + 2865 O -20.959975 8.707771 -3.841257 402 2866 2867 + 2866 H -20.129335 8.189240 -3.711541 403 2865 + 2867 H -21.648123 8.152127 -4.150679 403 2865 + 2868 O -16.180937 -14.560529 -11.236167 402 2869 2870 + 2869 H -16.474551 -15.471407 -11.472150 403 2868 + 2870 H -16.621414 -14.329172 -10.425074 403 2868 + 2871 O -13.342695 17.268978 -5.546108 402 2872 2873 + 2872 H -13.676329 17.161979 -6.427016 403 2871 + 2873 H -13.273106 16.392331 -5.194906 403 2871 + 2874 O -24.265742 -14.933019 -6.702562 402 2875 2876 + 2875 H -23.594698 -14.475474 -7.192272 403 2874 + 2876 H -24.769412 -14.353533 -6.144027 403 2874 + 2877 O -7.448634 4.091980 -14.623254 402 2878 2879 + 2878 H -8.354031 4.372416 -14.477512 403 2877 + 2879 H -7.429422 3.997857 -15.560262 403 2877 + 2880 O 20.945964 8.392028 7.273218 402 2881 2882 + 2881 H 20.936526 8.748124 8.157739 403 2880 + 2882 H 21.409383 8.938927 6.671909 403 2880 + 2883 O -18.135613 13.691026 0.855516 402 2884 2885 + 2884 H -17.605509 13.473951 1.604996 403 2883 + 2885 H -17.989769 12.903203 0.328977 403 2883 + 2886 O -26.399609 20.299424 -15.455568 402 2887 2888 + 2887 H -26.506532 19.402038 -15.778173 403 2886 + 2888 H -27.208559 20.540561 -15.036657 403 2886 + 2889 O -3.382080 16.857093 -8.397864 402 2890 2891 + 2890 H -3.374084 16.083688 -7.808965 403 2889 + 2891 H -4.084724 16.687463 -9.043127 403 2889 + 2892 O 16.271526 -9.902746 -4.216439 402 2893 2894 + 2893 H 16.409251 -10.505040 -3.454487 403 2892 + 2894 H 15.497720 -10.304168 -4.762308 403 2892 + 2895 O 14.340659 -16.032990 13.215463 402 2896 2897 + 2896 H 13.501340 -15.882091 13.690140 403 2895 + 2897 H 14.455052 -15.349188 12.509336 403 2895 + 2898 O -0.015146 -13.033200 3.303743 402 2899 2900 + 2899 H -0.181704 -13.007242 2.346702 403 2898 + 2900 H 0.267440 -13.997638 3.485458 403 2898 + 2901 O 17.219995 5.155984 2.579305 402 2902 2903 + 2902 H 17.867362 4.521907 2.914585 403 2901 + 2903 H 17.421034 5.907098 3.091911 403 2901 + 2904 O -4.290476 -8.859344 10.315396 402 2905 2906 + 2905 H -4.367776 -8.058305 9.793864 403 2904 + 2906 H -4.232508 -9.643259 9.792086 403 2904 + 2907 O -26.107401 19.840481 -9.535848 402 2908 2909 + 2908 H -25.152722 20.076292 -9.710007 403 2907 + 2909 H -26.580648 20.657816 -9.784705 403 2907 + 2910 O 22.430740 12.824805 -18.610921 402 2911 2912 + 2911 H 22.555563 12.342166 -17.752607 403 2910 + 2912 H 21.710766 13.488004 -18.415345 403 2910 + 2913 O -0.213702 15.539427 8.868930 402 2914 2915 + 2914 H 0.465115 15.308974 9.514310 403 2913 + 2915 H -0.991140 15.165260 9.301737 403 2913 + 2916 O 10.451773 19.296672 -15.739638 402 2917 2918 + 2917 H 11.250242 18.716315 -15.675225 403 2916 + 2918 H 10.166040 19.254066 -16.609341 403 2916 + 2919 O -16.340404 20.299845 -6.677501 402 2920 2921 + 2920 H -15.394517 20.367214 -6.949699 403 2919 + 2921 H -16.411819 19.609339 -6.000069 403 2919 + 2922 O 17.490554 18.048717 15.249869 402 2923 2924 + 2923 H 17.383710 17.561453 14.453086 403 2922 + 2924 H 17.231849 18.986361 14.979711 403 2922 + 2925 O -25.356900 0.960567 -15.630378 402 2926 2927 + 2926 H -25.668408 1.746466 -16.112686 403 2925 + 2927 H -25.749312 0.266373 -16.283472 403 2925 + 2928 O -24.523491 12.684913 -13.612913 402 2929 2930 + 2929 H -25.162839 13.082234 -14.200312 403 2928 + 2930 H -24.857615 11.766450 -13.558078 403 2928 + 2931 O -18.320478 -19.787535 -8.552256 402 2932 2933 + 2932 H -17.456232 -20.243682 -8.416866 403 2931 + 2933 H -18.816764 -20.212417 -7.902570 403 2931 + 2934 O -20.122796 -19.443402 14.311268 402 2935 2936 + 2935 H -20.955070 -19.458490 14.740741 403 2934 + 2936 H -20.448309 -19.736012 13.412761 403 2934 + 2937 O 15.526182 9.609189 7.445275 402 2938 2939 + 2938 H 16.546971 9.522464 7.260687 403 2937 + 2939 H 15.127662 8.717624 7.262881 403 2937 + 2940 O 21.815800 -13.876078 19.805359 402 2941 2942 + 2941 H 21.861374 -13.448639 20.652235 403 2940 + 2942 H 20.873448 -13.977249 19.618277 403 2940 + 2943 O -20.455209 -17.485281 2.435687 402 2944 2945 + 2944 H -20.514677 -18.504590 2.320539 403 2943 + 2945 H -19.650253 -17.416617 3.035233 403 2943 + 2946 O 12.598962 20.934840 -8.411100 402 2947 2948 + 2947 H 11.759105 20.691141 -7.924616 403 2946 + 2948 H 12.471156 20.908914 -9.376870 403 2946 + 2949 O -9.216318 -10.756192 8.704342 402 2950 2951 + 2950 H -9.035829 -9.823066 8.964150 403 2949 + 2951 H -10.158700 -10.965843 8.822969 403 2949 + 2952 O 15.481710 -19.357119 -11.731342 402 2953 2954 + 2953 H 16.266851 -18.921549 -11.423511 403 2952 + 2954 H 15.782813 -20.280095 -11.705706 403 2952 + 2955 O -15.247931 17.174276 -3.500551 402 2956 2957 + 2956 H -15.486872 16.716297 -4.319984 403 2955 + 2957 H -14.488844 17.725770 -3.787040 403 2955 + 2958 O 13.994416 -17.236082 0.675362 402 2959 2960 + 2959 H 14.353425 -17.278489 1.570062 403 2958 + 2960 H 14.236303 -16.341554 0.403337 403 2958 + 2961 O -23.467726 19.561551 3.571514 402 2962 2963 + 2962 H -24.004822 19.287615 4.359125 403 2961 + 2963 H -22.609407 19.390622 3.887076 403 2961 + 2964 O -18.884839 -16.840019 19.441419 402 2965 2966 + 2965 H -17.972164 -16.942648 19.429089 403 2964 + 2966 H -19.117567 -17.305223 18.656489 403 2964 + 2967 O -3.304416 17.688255 14.806768 402 2968 2969 + 2968 H -3.274068 18.569163 15.273992 403 2967 + 2969 H -3.909468 17.884508 14.115697 403 2967 + 2970 O -17.284600 -14.419545 -3.713924 402 2971 2972 + 2971 H -17.245841 -15.056389 -4.407408 403 2970 + 2972 H -16.814676 -13.644893 -4.121390 403 2970 + 2973 O -20.198946 13.854179 -11.126603 402 2974 2975 + 2974 H -19.842134 14.641594 -10.704689 403 2973 + 2975 H -20.994231 13.579588 -10.762730 403 2973 + 2976 O 19.633175 -4.534579 -1.940156 402 2977 2978 + 2977 H 20.573656 -4.404910 -1.787896 403 2976 + 2978 H 19.476036 -5.006335 -2.786939 403 2976 + 2979 O -14.050747 -7.840313 -20.451392 402 2980 2981 + 2980 H -13.804502 -7.885621 -19.536069 403 2979 + 2981 H -14.163116 -8.770871 -20.729134 403 2979 + 2982 O -22.035810 -14.696947 -15.342419 402 2983 2984 + 2983 H -21.244458 -14.172213 -14.968853 403 2982 + 2984 H -21.709618 -15.071176 -16.129917 403 2982 + 2985 O 24.404519 18.662499 15.604580 402 2986 2987 + 2986 H 23.649634 19.231742 15.720672 403 2985 + 2987 H 24.564861 18.257635 16.462026 403 2985 + 2988 O -25.023703 1.632995 9.069342 402 2989 2990 + 2989 H -24.924833 0.728361 9.205894 403 2988 + 2990 H -25.848027 1.691778 8.537435 403 2988 + 2991 O -23.501597 20.098664 7.878789 402 2992 2993 + 2992 H -23.060988 19.669189 7.073786 403 2991 + 2993 H -24.179799 19.453525 8.025704 403 2991 + 2994 O -19.949605 3.791557 -8.640569 402 2995 2996 + 2995 H -20.735484 4.236110 -9.006112 403 2994 + 2996 H -20.021037 3.910265 -7.668204 403 2994 + 2997 O -11.039604 7.965462 12.985718 402 2998 2999 + 2998 H -11.657528 7.295810 13.344834 403 2997 + 2999 H -11.533657 8.735729 12.733347 403 2997 + 3000 O -10.874373 -9.234080 16.940331 402 3001 3002 + 3001 H -10.287226 -8.454268 16.808084 403 3000 + 3002 H -10.829657 -9.367499 17.890097 403 3000 + 3003 O -14.385649 -14.739019 19.039927 402 3004 3005 + 3004 H -15.014366 -15.430322 18.739868 403 3003 + 3005 H -13.950162 -14.385374 18.202705 403 3003 + 3006 O -8.943007 -18.707640 -12.863046 402 3007 3008 + 3007 H -8.324251 -18.030317 -12.441569 403 3006 + 3008 H -8.503951 -19.555164 -12.986191 403 3006 + 3009 O -12.368468 -11.299670 18.862003 402 3010 3011 + 3010 H -11.462838 -11.162374 19.089512 403 3009 + 3011 H -12.285975 -11.967140 18.162474 403 3009 + 3012 O -18.864908 10.893225 -18.642183 402 3013 3014 + 3013 H -19.737729 11.286548 -18.797146 403 3012 + 3014 H -18.291730 11.691326 -18.413733 403 3012 + 3015 O 13.738555 -10.387697 15.727067 402 3016 3017 + 3016 H 14.677946 -10.190824 15.738680 403 3015 + 3017 H 13.381035 -9.878174 14.979047 403 3015 + 3018 O -21.819721 -0.482540 -14.130337 402 3019 3020 + 3019 H -22.018580 0.101499 -14.814948 403 3018 + 3020 H -21.732054 0.043937 -13.284517 403 3018 + 3021 O -22.088145 -19.005770 -10.424446 402 3022 3023 + 3022 H -22.700458 -18.735873 -11.127116 403 3021 + 3023 H -22.265806 -18.243802 -9.851663 403 3021 + 3024 O -27.334131 16.862943 6.388414 402 3025 3026 + 3025 H -27.128884 17.208336 5.542208 403 3024 + 3026 H -28.186942 16.459356 6.245911 403 3024 + 3027 O -7.724914 11.617317 -15.852447 402 3028 3029 + 3028 H -7.898781 11.683763 -14.888607 403 3027 + 3029 H -7.243883 12.459704 -15.934395 403 3027 + 3030 O -27.430510 7.062419 7.641894 402 3031 3032 + 3031 H -28.241619 7.496835 7.830929 403 3030 + 3032 H -26.905937 6.864821 8.456222 403 3030 + 3033 O -15.189130 9.068233 11.973047 402 3034 3035 + 3034 H -15.507439 9.270556 11.066477 403 3033 + 3035 H -16.000569 9.109399 12.508881 403 3033 + 3036 O 18.197719 -8.444367 -5.807006 402 3037 3038 + 3037 H 17.669265 -7.953475 -6.477556 403 3036 + 3038 H 17.491033 -8.840952 -5.199557 403 3036 + 3039 O -17.798267 -15.359279 0.720984 402 3040 3041 + 3040 H -17.605358 -16.253295 0.449070 403 3039 + 3041 H -18.769315 -15.298569 0.739208 403 3039 + 3042 O -10.801299 19.625083 -5.021468 402 3043 3044 + 3043 H -9.963843 19.123292 -5.234694 403 3042 + 3044 H -10.501894 20.547773 -4.927487 403 3042 + 3045 O -27.215648 6.353394 -6.216686 402 3046 3047 + 3046 H -27.824477 6.975672 -6.597897 403 3045 + 3047 H -27.715217 5.539077 -6.142494 403 3045 + 3048 O -20.222710 16.482564 20.889728 402 3049 3050 + 3049 H -19.409945 15.875063 20.936404 403 3048 + 3050 H -20.827135 16.165289 21.596363 403 3048 + 3051 O -15.955148 20.970093 -1.473146 402 3052 3053 + 3052 H -16.254513 20.076270 -1.042106 403 3051 + 3053 H -15.662348 21.552087 -0.814219 403 3051 + 3054 O 10.807526 -13.982475 1.662510 402 3055 3056 + 3055 H 10.120672 -14.259351 2.204544 403 3054 + 3056 H 10.863967 -13.021251 1.772688 403 3054 + 3057 O -7.966458 -18.779639 13.245673 402 3058 3059 + 3058 H -7.309099 -18.332730 12.718011 403 3057 + 3059 H -8.719738 -18.984231 12.613154 403 3057 + 3060 O -20.403821 -13.506340 10.662924 402 3061 3062 + 3061 H -20.510093 -14.184751 11.331921 403 3060 + 3062 H -19.449692 -13.488641 10.607253 403 3060 + 3063 O 3.347403 17.582790 14.279585 402 3064 3065 + 3064 H 3.542375 16.697267 14.539882 403 3063 + 3065 H 3.842808 18.157712 14.875497 403 3063 + 3066 O -27.268704 11.599332 7.521962 402 3067 3068 + 3067 H -27.319935 12.603952 7.610238 403 3066 + 3068 H -27.760414 11.222738 8.251319 403 3066 + 3069 O -13.558625 -13.571833 9.018373 402 3070 3071 + 3070 H -14.134501 -13.113855 9.622383 403 3069 + 3071 H -13.282735 -12.952963 8.287428 403 3069 + 3072 O -12.904629 4.779698 8.188511 402 3073 3074 + 3073 H -12.946789 5.709486 7.819080 403 3072 + 3074 H -13.125056 4.225008 7.389046 403 3072 + 3075 O -26.521845 8.632500 -1.585840 402 3076 3077 + 3076 H -27.252112 8.571224 -0.926514 403 3075 + 3077 H -27.101821 8.697912 -2.395641 403 3075 + 3078 O 0.711352 18.247453 15.282784 402 3079 3080 + 3079 H 1.603697 18.249814 14.962197 403 3078 + 3080 H 0.201613 17.732907 14.670147 403 3078 + 3081 O 7.113451 16.228888 -1.466776 402 3082 3083 + 3082 H 7.173117 15.305699 -1.111399 403 3081 + 3083 H 7.220512 16.670305 -0.601189 403 3081 + 3084 O -13.904243 8.625524 20.904818 402 3085 3086 + 3085 H -14.598235 8.427161 20.276223 403 3084 + 3086 H -13.595573 9.537530 20.812383 403 3084 + 3087 O -23.282747 7.422865 -4.367991 402 3088 3089 + 3088 H -23.494082 7.124036 -5.259399 403 3087 + 3089 H -24.056516 7.114406 -3.864243 403 3087 + 3090 O -14.263410 11.647626 -16.485013 402 3091 3092 + 3091 H -14.250457 12.591263 -16.217484 403 3090 + 3092 H -13.447733 11.223560 -16.266518 403 3090 + 3093 O -25.123489 -11.752131 6.663069 402 3094 3095 + 3094 H -24.434538 -11.175706 6.315833 403 3093 + 3095 H -24.632736 -12.584077 6.767142 403 3093 + 3096 O -14.146070 -17.326290 5.680123 402 3097 3098 + 3097 H -13.644335 -16.487658 5.902302 403 3096 + 3098 H -14.878124 -17.344106 6.279009 403 3096 + 3099 O -20.598314 9.096753 20.421892 402 3100 3101 + 3100 H -21.420000 9.436011 20.788368 403 3099 + 3101 H -20.773261 8.800990 19.535216 403 3099 + 3102 O 18.231067 -8.355182 -15.374644 402 3103 3104 + 3103 H 19.158997 -8.699272 -15.469475 403 3102 + 3104 H 18.162062 -7.866000 -14.601450 403 3102 + 3105 O -26.082795 17.419257 -15.113528 402 3106 3107 + 3106 H -26.663305 16.880075 -15.659385 403 3105 + 3107 H -26.614420 17.764627 -14.366811 403 3105 + 3108 O -4.564502 -6.365364 18.192018 402 3109 3110 + 3109 H -4.423912 -6.577366 17.248668 403 3108 + 3110 H -4.413382 -7.162274 18.732886 403 3108 + 3111 O 2.994631 -20.344673 -10.462592 402 3112 3113 + 3112 H 3.336979 -19.647973 -11.071544 403 3111 + 3113 H 2.839013 -21.162093 -11.031196 403 3111 + 3114 O -18.808948 18.745667 8.606647 402 3115 3116 + 3115 H -18.793078 17.928925 9.047490 403 3114 + 3116 H -19.375318 18.782786 7.854831 403 3114 + 3117 O 20.293384 6.483656 -8.185168 402 3118 3119 + 3118 H 19.822775 6.335085 -7.339796 403 3117 + 3119 H 19.910867 5.733330 -8.676027 403 3117 + 3120 O 14.001637 -11.377427 6.654390 402 3121 3122 + 3121 H 14.665802 -10.891103 7.186571 403 3120 + 3122 H 13.155623 -11.243569 7.110824 403 3120 + 3123 O -18.716197 16.452296 -6.146582 402 3124 3125 + 3124 H -17.737092 16.308167 -6.065641 403 3123 + 3125 H -18.803071 17.441704 -6.266673 403 3123 + 3126 O -9.164502 -4.245435 9.687071 402 3127 3128 + 3127 H -9.504754 -3.618059 10.271725 403 3126 + 3128 H -8.758976 -4.901714 10.277390 403 3126 + 3129 O -7.567104 17.996846 -14.273209 402 3130 3131 + 3130 H -7.423981 17.432000 -15.103459 403 3129 + 3131 H -7.626914 17.354562 -13.501068 403 3129 + 3132 O 25.957404 18.297560 0.964228 402 3133 3134 + 3133 H 26.373386 18.902213 1.607245 403 3132 + 3134 H 24.996135 18.298154 0.948557 403 3132 + 3135 O 27.365655 -19.507447 4.283366 402 3136 3137 + 3136 H 27.265808 -18.590346 4.470644 403 3135 + 3137 H 27.346229 -19.502059 3.318095 403 3135 + 3138 O 3.399017 3.842973 -14.306661 402 3139 3140 + 3139 H 3.874219 4.645706 -14.438487 403 3138 + 3140 H 3.960550 3.060792 -14.302404 403 3138 + 3141 O -9.633558 -14.252688 -13.074954 402 3142 3143 + 3142 H -10.397961 -14.800052 -13.280458 403 3141 + 3143 H -9.599658 -13.580050 -13.748986 403 3141 + 3144 O -26.597184 -9.526044 16.214934 402 3145 3146 + 3145 H -25.761551 -9.704064 15.705422 403 3144 + 3146 H -26.282395 -9.291353 17.107825 403 3144 + 3147 O 9.904852 -8.080714 13.028578 402 3148 3149 + 3148 H 9.633649 -8.672937 13.775436 403 3147 + 3149 H 9.328640 -8.216914 12.289674 403 3147 + 3150 O -16.656465 -15.275719 14.920535 402 3151 3152 + 3151 H -16.332015 -16.176602 15.149012 403 3150 + 3152 H -17.604168 -15.312599 15.097227 403 3150 + 3153 O -23.632856 16.383578 4.244499 402 3154 3155 + 3154 H -24.439865 15.907903 4.567947 403 3153 + 3155 H -23.758905 16.459340 3.297146 403 3153 + 3156 O 6.174822 3.396366 6.558333 402 3157 3158 + 3157 H 6.411031 3.086511 7.491490 403 3156 + 3158 H 5.914298 2.639627 6.072475 403 3156 + 3159 O -12.394642 12.999960 5.615295 402 3160 3161 + 3160 H -12.767249 13.829992 5.894454 403 3159 + 3161 H -11.542368 12.942527 6.067628 403 3159 + 3162 O -13.943061 -10.506777 -8.106784 402 3163 3164 + 3163 H -14.282580 -10.512566 -7.188555 403 3162 + 3164 H -13.832495 -9.541181 -8.393822 403 3162 + 3165 O -2.132377 12.062639 -15.645930 402 3166 3167 + 3166 H -2.521581 12.726985 -15.116060 403 3165 + 3167 H -2.383415 12.256835 -16.605675 403 3165 + 3168 O -15.781380 4.295423 -12.837615 402 3169 3170 + 3169 H -16.545564 4.857521 -12.623883 403 3168 + 3170 H -14.991403 4.649584 -12.386947 403 3168 + 3171 O 3.657686 -14.899636 11.284985 402 3172 3173 + 3172 H 4.599918 -15.027083 11.351362 403 3171 + 3173 H 3.451904 -14.114684 10.742312 403 3171 + 3174 O -13.445931 -12.269834 -16.644595 402 3175 3176 + 3175 H -13.143553 -12.206221 -17.543310 403 3174 + 3176 H -14.277341 -11.802665 -16.570144 403 3174 + 3177 O -4.514598 -14.412565 -11.239008 402 3178 3179 + 3178 H -4.912249 -14.782052 -10.430067 403 3177 + 3179 H -5.207582 -13.911802 -11.682506 403 3177 + 3180 O -22.202449 -8.277754 -0.156304 402 3181 3182 + 3181 H -21.822932 -9.154115 -0.107154 403 3180 + 3182 H -22.081748 -7.881016 0.675063 403 3180 + 3183 O 5.980605 9.643233 7.937147 402 3184 3185 + 3184 H 5.778293 9.935793 8.831204 403 3183 + 3185 H 6.322796 10.408255 7.426496 403 3183 + 3186 O -2.201607 -16.515113 -14.210032 402 3187 3188 + 3187 H -2.059974 -15.558981 -14.035317 403 3186 + 3188 H -1.990188 -17.058199 -13.410631 403 3186 + 3189 O 18.679591 -18.705711 14.460946 402 3190 3191 + 3190 H 18.696979 -17.793354 14.872009 403 3189 + 3191 H 19.598133 -18.732862 14.241557 403 3189 + 3192 O -23.704300 9.078870 13.078638 402 3193 3194 + 3193 H -23.670653 8.205186 13.541582 403 3192 + 3194 H -24.192847 9.646015 13.627775 403 3192 + 3195 O -2.173657 16.833015 -11.939576 402 3196 3197 + 3196 H -1.811491 16.347920 -12.704849 403 3195 + 3197 H -1.445451 17.452841 -11.775832 403 3195 + 3198 O 13.483501 -11.256705 11.913651 402 3199 3200 + 3199 H 12.870120 -10.662512 12.431360 403 3198 + 3200 H 14.331458 -10.851122 11.936251 403 3198 + 3201 O 24.414471 -17.245267 11.179269 402 3202 3203 + 3202 H 25.211262 -16.789228 11.385933 403 3201 + 3203 H 24.640242 -18.219159 11.091473 403 3201 + 3204 O 11.120331 -15.111988 5.927148 402 3205 3206 + 3205 H 11.451561 -14.918986 6.814295 403 3204 + 3206 H 11.019394 -14.187742 5.582882 403 3204 + 3207 O 12.007104 -9.600387 4.572911 402 3208 3209 + 3208 H 11.779325 -9.981896 3.630934 403 3207 + 3209 H 12.299473 -8.663707 4.379041 403 3207 + 3210 O 6.432204 5.492806 -11.438378 402 3211 3212 + 3211 H 6.858563 6.325600 -11.691904 403 3210 + 3212 H 5.497288 5.536187 -11.496269 403 3210 + 3213 O -16.803408 -2.309975 -12.525084 402 3214 3215 + 3214 H -17.553689 -1.730249 -12.823644 403 3213 + 3215 H -17.150179 -3.188627 -12.867169 403 3213 + 3216 O -2.408853 19.363640 5.416041 402 3217 3218 + 3217 H -2.506588 20.324223 5.172630 403 3216 + 3218 H -1.499205 19.245311 4.997471 403 3216 + 3219 O 18.335645 9.820504 -20.835302 402 3220 3221 + 3220 H 17.802051 9.406337 -21.556671 403 3219 + 3221 H 19.054571 10.173338 -21.326492 403 3219 + 3222 O 14.492400 -0.793925 15.043220 402 3223 3224 + 3223 H 15.273199 -0.763837 15.602226 403 3222 + 3224 H 13.903082 -0.202173 15.510237 403 3222 + 3225 O -18.990417 -18.003103 -15.160778 402 3226 3227 + 3226 H -19.065422 -18.467887 -14.363137 403 3225 + 3227 H -18.682751 -18.771930 -15.707456 403 3225 + 3228 O -19.355981 10.428580 -15.655699 402 3229 3230 + 3229 H -18.958237 10.419569 -16.503824 403 3228 + 3230 H -19.555621 9.469325 -15.477396 403 3228 + 3231 O -9.689572 -17.625802 20.274891 402 3232 3233 + 3232 H -9.638458 -16.856491 19.680753 403 3231 + 3233 H -10.446575 -18.157818 20.089513 403 3231 + 3234 O 15.818186 -2.858530 -17.669337 402 3235 3236 + 3235 H 15.374117 -2.032149 -17.355590 403 3234 + 3236 H 16.772354 -2.603400 -17.785321 403 3234 + 3237 O 4.606592 -16.002710 16.812249 402 3238 3239 + 3238 H 5.315620 -15.500456 17.249944 403 3237 + 3239 H 3.799748 -15.479801 16.918622 403 3237 + 3240 O -21.513339 9.988705 -9.339870 402 3241 3242 + 3241 H -20.667999 10.159257 -9.025723 403 3240 + 3242 H -21.969690 9.708425 -8.552482 403 3240 + 3243 O 22.932065 -4.395951 1.502838 402 3244 3245 + 3244 H 23.014854 -3.682098 2.132967 403 3243 + 3245 H 22.755233 -5.203260 2.068576 403 3243 + 3246 O -15.865161 20.547416 -16.433392 402 3247 3248 + 3247 H -15.771392 21.394273 -16.845693 403 3246 + 3248 H -15.137003 20.501933 -15.748936 403 3246 + 3249 O 25.069907 -16.838970 -4.299599 402 3250 3251 + 3250 H 25.999382 -16.506367 -4.277797 403 3249 + 3251 H 24.882196 -17.073394 -3.399165 403 3249 + 3252 O 12.210843 -6.139817 11.421079 402 3253 3254 + 3253 H 11.494183 -5.792293 10.826764 403 3252 + 3254 H 12.753399 -6.598677 10.772296 403 3252 + 3255 O -12.958185 15.721214 20.131937 402 3256 3257 + 3256 H -12.417015 15.448234 19.335440 403 3255 + 3257 H -12.670185 16.622230 20.361377 403 3255 + 3258 O -1.787017 -16.482436 -2.383044 402 3259 3260 + 3259 H -1.225925 -16.053148 -3.012278 403 3258 + 3260 H -2.501380 -15.880251 -2.214679 403 3258 + 3261 O -1.190078 -20.139554 1.294226 402 3262 3263 + 3262 H -0.299194 -20.371113 0.969279 403 3261 + 3263 H -1.688402 -19.692251 0.619486 403 3261 + 3264 O 1.937567 -19.455705 20.174807 402 3265 3266 + 3265 H 1.600890 -18.656647 20.650502 403 3264 + 3266 H 2.270116 -20.076098 20.862273 403 3264 + 3267 O -13.809787 16.178967 11.484043 402 3268 3269 + 3268 H -14.142545 15.377181 11.850775 403 3267 + 3269 H -14.373329 16.882494 11.935295 403 3267 + 3270 O 17.196672 -3.298677 9.603341 402 3271 3272 + 3271 H 17.785156 -3.273949 10.352111 403 3270 + 3272 H 16.328249 -3.307055 9.989818 403 3270 + 3273 O -21.793083 12.953802 -3.361588 402 3274 3275 + 3274 H -21.341354 13.824014 -3.442583 403 3273 + 3275 H -21.956486 12.886091 -2.420332 403 3273 + 3276 O 24.722833 -20.214271 -1.932412 402 3277 3278 + 3277 H 24.583170 -20.295689 -2.905459 403 3276 + 3278 H 25.266330 -20.988208 -1.659517 403 3276 + 3279 O 13.576953 15.549687 -14.568922 402 3280 3281 + 3280 H 13.196035 16.082140 -13.845167 403 3279 + 3281 H 12.903095 14.935032 -14.704323 403 3279 + 3282 O 24.686323 18.724782 9.264820 402 3283 3284 + 3283 H 25.356258 19.231143 8.760904 403 3282 + 3284 H 24.376076 19.091122 10.133820 403 3282 + 3285 O 10.974277 8.210457 0.042398 402 3286 3287 + 3286 H 10.346946 8.747962 0.639501 403 3285 + 3287 H 11.775308 8.082914 0.592641 403 3285 + 3288 O 15.749941 -9.949096 -10.535727 402 3289 3290 + 3289 H 14.881677 -9.994266 -10.933909 403 3288 + 3290 H 16.082746 -9.069742 -10.712222 403 3288 + 3291 O 20.372551 -2.740524 -20.295283 402 3292 3293 + 3292 H 19.972569 -3.556917 -19.910575 403 3291 + 3293 H 21.117159 -2.669954 -19.650483 403 3291 + 3294 O -16.130593 19.525141 7.609103 402 3295 3296 + 3295 H -16.988329 19.095523 7.574165 403 3294 + 3296 H -15.815635 19.368486 8.484111 403 3294 + 3297 O -13.620470 -12.179873 -20.763485 402 3298 3299 + 3298 H -13.206848 -12.281384 -21.584939 403 3297 + 3299 H -13.003543 -11.952064 -20.092320 403 3297 + 3300 O -4.286145 -8.076676 -19.850653 402 3301 3302 + 3301 H -4.024629 -8.962570 -19.497729 403 3300 + 3302 H -4.628013 -8.265378 -20.732144 403 3300 + 3303 O 18.167149 11.171401 14.365772 402 3304 3305 + 3304 H 18.072419 11.267858 15.337991 403 3303 + 3305 H 19.114984 11.092302 14.227006 403 3303 + 3306 O -6.484207 14.268929 15.251307 402 3307 3308 + 3307 H -5.622289 14.569256 15.414810 403 3306 + 3308 H -6.409671 13.589284 14.542615 403 3306 + 3309 O -22.009910 15.740037 8.254841 402 3310 3311 + 3310 H -21.174881 15.566577 7.788279 403 3309 + 3311 H -21.784303 15.725302 9.211467 403 3309 + 3312 O -12.075884 4.855934 18.759604 402 3313 3314 + 3313 H -11.922580 5.826978 18.890965 403 3312 + 3314 H -11.210639 4.506344 19.097368 403 3312 + 3315 O 10.488011 -18.196911 -8.466384 402 3316 3317 + 3316 H 10.637969 -17.211540 -8.520849 403 3315 + 3317 H 11.163762 -18.500106 -9.085738 403 3315 + 3318 O 1.125820 20.066151 11.277514 402 3319 3320 + 3319 H 0.488344 19.358887 11.406985 403 3318 + 3320 H 1.175707 20.424035 12.220043 403 3318 + 3321 O 1.508244 -2.375369 14.307932 402 3322 3323 + 3322 H 0.868346 -1.761280 14.698396 403 3321 + 3323 H 1.257101 -3.281035 14.657092 403 3321 + 3324 O 8.333201 -20.303098 14.135689 402 3325 3326 + 3325 H 8.173342 -20.812430 14.996202 403 3324 + 3326 H 7.563231 -20.469348 13.580696 403 3324 + 3327 O 7.161769 13.324939 -3.684466 402 3328 3329 + 3328 H 6.692561 13.032914 -4.505707 403 3327 + 3329 H 7.435294 14.252208 -3.751921 403 3327 + 3330 O -8.368806 1.641675 18.686706 402 3331 3332 + 3331 H -7.449000 1.561105 18.992044 403 3330 + 3332 H -8.829402 1.367359 19.523867 403 3330 + 3333 O 4.081470 8.393376 14.788004 402 3334 3335 + 3334 H 3.416356 8.289314 15.434673 403 3333 + 3335 H 3.901559 7.693490 14.181822 403 3333 + 3336 O -7.418847 -5.372814 17.842250 402 3337 3338 + 3337 H -7.820918 -6.206339 17.693835 403 3336 + 3338 H -6.460103 -5.466581 17.841167 403 3336 + 3339 O -6.272338 -9.280731 3.614771 402 3340 3341 + 3340 H -5.671659 -9.851333 3.097194 403 3339 + 3341 H -6.583386 -9.880058 4.252855 403 3339 + 3342 O 26.867212 -7.498721 15.184014 402 3343 3344 + 3343 H 27.180613 -8.176302 15.786609 403 3342 + 3344 H 27.338168 -7.770453 14.373438 403 3342 + 3345 O 9.996033 -14.570233 13.333736 402 3346 3347 + 3346 H 9.969634 -13.724445 12.959529 403 3345 + 3347 H 9.789000 -15.194125 12.559782 403 3345 + 3348 O 2.391061 -15.016416 -4.564378 402 3349 3350 + 3349 H 2.249440 -15.150315 -3.614545 403 3348 + 3350 H 3.332088 -14.950210 -4.710721 403 3348 + 3351 O -21.651564 17.273027 -5.114431 402 3352 3353 + 3352 H -22.612266 17.402180 -4.967856 403 3351 + 3353 H -21.475301 17.110688 -6.035544 403 3351 + 3354 O 10.670434 18.798919 9.295678 402 3355 3356 + 3355 H 10.772878 18.810256 8.313948 403 3354 + 3356 H 10.935580 19.678994 9.619801 403 3354 + 3357 O 8.580286 -14.501479 3.135425 402 3358 3359 + 3358 H 8.621343 -14.445805 4.107721 403 3357 + 3359 H 8.542982 -15.491097 3.062040 403 3357 + 3360 O -14.377865 -7.995183 14.343301 402 3361 3362 + 3361 H -14.100201 -8.614257 14.993234 403 3360 + 3362 H -14.866324 -7.355345 14.871637 403 3360 + 3363 O -0.977425 16.774193 13.640180 402 3364 3365 + 3364 H -0.958949 17.266593 12.835191 403 3363 + 3365 H -1.881684 16.955536 13.931092 403 3363 + 3366 O -15.828708 -3.415349 7.406744 402 3367 3368 + 3367 H -16.180618 -3.426100 6.520488 403 3366 + 3368 H -16.669651 -3.380771 7.995037 403 3366 + 3369 O -12.774799 -8.235123 -12.889327 402 3370 3371 + 3370 H -12.978669 -7.282136 -13.083792 403 3369 + 3371 H -13.615071 -8.678664 -13.235742 403 3369 + 3372 O 2.845289 0.060180 20.134181 402 3373 3374 + 3373 H 2.858756 0.453048 19.232311 403 3372 + 3374 H 1.957136 -0.331348 20.300492 403 3372 + 3375 O 24.984643 -14.973253 -17.474954 402 3376 3377 + 3376 H 25.370717 -15.847238 -17.382478 403 3375 + 3377 H 25.194569 -14.524794 -16.625306 403 3375 + 3378 O 13.620247 -7.920957 7.008348 402 3379 3380 + 3379 H 14.470702 -8.278296 6.767655 403 3378 + 3380 H 13.126236 -7.674429 6.169358 403 3378 + 3381 O 17.636081 -10.073874 3.386982 402 3382 3383 + 3382 H 17.376472 -9.849973 2.460148 403 3381 + 3383 H 17.541385 -10.988029 3.459151 403 3381 + 3384 O -23.876026 -12.063687 -5.995846 402 3385 3386 + 3385 H -24.585420 -12.252172 -5.420831 403 3384 + 3386 H -23.110219 -12.523733 -5.650434 403 3384 + 3387 O -23.535607 1.699271 1.932031 402 3388 3389 + 3388 H -24.143027 1.031548 1.814474 403 3387 + 3389 H -23.866587 2.338510 2.606284 403 3387 + 3390 O 13.720565 9.351789 12.307976 402 3391 3392 + 3391 H 13.899370 10.225405 12.040604 403 3390 + 3392 H 13.192298 9.477241 13.121209 403 3390 + 3393 O 15.291476 15.170550 12.140656 402 3394 3395 + 3394 H 14.287956 15.135496 12.069067 403 3393 + 3395 H 15.572140 14.570493 11.432982 403 3393 + 3396 O -10.060226 -11.465180 13.094454 402 3397 3398 + 3397 H -9.757397 -11.240849 13.961157 403 3396 + 3398 H -9.428065 -11.417927 12.436211 403 3396 + 3399 O -19.840622 -4.281655 -17.053557 402 3400 3401 + 3400 H -20.444679 -3.559033 -16.740868 403 3399 + 3401 H -20.093102 -5.062268 -16.449961 403 3399 + 3402 O -11.088232 19.299933 12.989268 402 3403 3404 + 3403 H -11.278861 18.327556 12.943710 403 3402 + 3404 H -10.555994 19.370336 13.806383 403 3402 + 3405 O 14.192836 -14.527612 16.897429 402 3406 3407 + 3406 H 13.394071 -15.012895 17.049022 403 3405 + 3407 H 14.074952 -14.064189 16.039244 403 3405 + 3408 O 5.078670 -4.434084 15.727807 402 3409 3410 + 3409 H 5.834022 -4.419315 16.349614 403 3408 + 3410 H 5.405954 -4.558925 14.872493 403 3408 + 3411 O -19.510762 -4.936357 -8.682052 402 3412 3413 + 3412 H -18.583830 -4.871299 -8.739257 403 3411 + 3413 H -19.725350 -4.373920 -7.917441 403 3411 + 3414 O 6.637127 -10.197837 -8.914867 402 3415 3416 + 3415 H 7.303561 -10.846941 -9.129195 403 3414 + 3416 H 7.018008 -9.736820 -8.200293 403 3414 + 3417 O -23.721355 20.227172 -16.438294 402 3418 3419 + 3418 H -24.533045 20.118818 -15.892499 403 3417 + 3419 H -24.022901 20.350741 -17.335304 403 3417 + 3420 O -0.030599 -15.820284 7.354097 402 3421 3422 + 3421 H -0.675125 -15.374015 6.761895 403 3420 + 3422 H -0.583629 -16.217933 8.065590 403 3420 + 3423 O 17.878609 -6.751885 -17.518842 402 3424 3425 + 3424 H 17.903391 -7.334049 -16.742820 403 3423 + 3425 H 17.140042 -7.214968 -18.038372 403 3423 + 3426 O -5.849569 3.309930 19.753024 402 3427 3428 + 3427 H -6.252138 4.072448 20.161965 403 3426 + 3428 H -5.149208 3.038493 20.337689 403 3426 + 3429 O -24.710885 -6.308647 13.490216 402 3430 3431 + 3430 H -25.586238 -6.177846 13.106753 403 3429 + 3431 H -24.889314 -6.461576 14.430169 403 3429 + 3432 O -11.604329 -16.031249 -0.237137 402 3433 3434 + 3433 H -10.966421 -16.304157 -0.881127 403 3432 + 3434 H -11.170811 -15.476610 0.378509 403 3432 + 3435 O 21.103321 -18.752766 6.405335 402 3436 3437 + 3436 H 21.283349 -17.950114 6.943720 403 3435 + 3437 H 21.235391 -18.472219 5.506239 403 3435 + 3438 O -0.369145 -20.712312 19.095306 402 3439 3440 + 3439 H 0.355231 -20.367028 19.676247 403 3438 + 3440 H -1.186977 -20.260183 19.421119 403 3438 + 3441 O 13.869578 -2.965624 18.758945 402 3442 3443 + 3442 H 13.547281 -3.390529 19.570053 403 3441 + 3443 H 14.278344 -2.158860 19.065428 403 3441 + 3444 O -15.806264 2.737988 -2.216704 402 3445 3446 + 3445 H -16.485177 2.180539 -1.805532 403 3444 + 3446 H -15.814791 2.396599 -3.131246 403 3444 + 3447 O -11.766416 -8.088239 8.837485 402 3448 3449 + 3448 H -11.812419 -8.926527 9.226533 403 3447 + 3449 H -12.558194 -7.583042 9.186828 403 3447 + 3450 O 23.076788 16.678629 12.104295 402 3451 3452 + 3451 H 23.468754 16.241536 11.310898 403 3450 + 3452 H 22.132874 16.713960 11.904816 403 3450 + 3453 O -14.202464 -15.765503 -5.593495 402 3454 3455 + 3454 H -14.871838 -15.026911 -5.676361 403 3453 + 3455 H -13.955401 -15.992753 -6.481500 403 3453 + 3456 O 15.150303 11.672770 19.298045 402 3457 3458 + 3457 H 15.470730 12.261881 18.627217 403 3456 + 3458 H 15.518028 11.969931 20.141796 403 3456 + 3459 O 9.848503 -12.101587 -10.529245 402 3460 3461 + 3460 H 10.607536 -11.738045 -10.041608 403 3459 + 3461 H 9.985842 -11.615457 -11.376399 403 3459 + 3462 O 2.125570 -11.875883 -16.645987 402 3463 3464 + 3463 H 2.047554 -12.712083 -16.165814 403 3462 + 3464 H 2.067413 -12.170151 -17.579365 403 3462 + 3465 O -5.977611 10.651495 7.046682 402 3466 3467 + 3466 H -5.213541 10.455986 7.620137 403 3465 + 3467 H -6.494562 9.846985 7.169759 403 3465 + 3468 O -16.351535 -7.485266 -9.424947 402 3469 3470 + 3469 H -16.745079 -6.668906 -9.070767 403 3468 + 3470 H -16.602332 -8.158689 -8.798627 403 3468 + 3471 O 24.296678 -17.192464 4.785797 402 3472 3473 + 3472 H 24.587865 -18.035334 5.123313 403 3471 + 3473 H 24.068802 -16.574501 5.523851 403 3471 + 3474 O -10.968856 -18.323021 -8.138707 402 3475 3476 + 3475 H -11.363544 -18.853138 -8.863013 403 3474 + 3476 H -10.206142 -17.988660 -8.562061 403 3474 + 3477 O -9.854962 -9.956148 -15.278228 402 3478 3479 + 3478 H -10.293465 -9.897483 -14.451993 403 3477 + 3479 H -9.970473 -10.887047 -15.573043 403 3477 + 3480 O -2.935483 6.363032 -19.045018 402 3481 3482 + 3481 H -3.535132 5.588364 -18.854687 403 3480 + 3482 H -3.494550 7.145960 -19.014910 403 3480 + 3483 O 5.112400 17.701587 -11.443651 402 3484 3485 + 3484 H 5.575170 17.705031 -12.266361 403 3483 + 3485 H 5.677404 18.265335 -10.960537 403 3483 + 3486 O -6.450118 17.009140 6.526693 402 3487 3488 + 3487 H -6.743394 16.108032 6.566324 403 3486 + 3488 H -5.677664 17.076672 5.879731 403 3486 + 3489 O 13.801680 -10.581422 -18.444834 402 3490 3491 + 3490 H 14.024633 -10.709852 -17.519503 403 3489 + 3491 H 14.526918 -10.713699 -19.015218 403 3489 + 3492 O -26.491618 -8.486894 -15.884962 402 3493 3494 + 3493 H -26.227094 -9.167912 -16.481603 403 3492 + 3494 H -27.254427 -8.747438 -15.427464 403 3492 + 3495 O 9.041006 -18.956744 11.010081 402 3496 3497 + 3496 H 9.242427 -19.133960 10.087876 403 3495 + 3497 H 9.841718 -19.136012 11.534074 403 3495 + 3498 O -14.427557 4.070601 -15.330760 402 3499 3500 + 3499 H -14.952347 4.033207 -14.554014 403 3498 + 3500 H -14.812926 4.741427 -15.800456 403 3498 + 3501 O 17.060580 -3.941095 -20.977244 402 3502 3503 + 3502 H 17.749250 -4.204310 -20.329442 403 3501 + 3503 H 16.300042 -3.942896 -20.427486 403 3501 + 3504 O -23.014194 6.362529 14.192538 402 3505 3506 + 3505 H -23.324814 5.470443 14.451595 403 3504 + 3506 H -22.082482 6.279068 14.241974 403 3504 + 3507 O -25.628726 -6.961569 -2.257843 402 3508 3509 + 3508 H -25.574604 -7.184504 -1.341207 403 3507 + 3509 H -26.582064 -6.786831 -2.353726 403 3507 + 3510 O 22.564240 2.932310 -9.807597 402 3511 3512 + 3511 H 23.151969 3.604785 -10.163343 403 3510 + 3512 H 22.874635 2.102350 -10.219491 403 3510 + 3513 O -3.253479 19.088800 -17.106412 402 3514 3515 + 3514 H -2.788864 19.318234 -16.243589 403 3513 + 3515 H -2.764381 19.537649 -17.806531 403 3513 + 3516 O -22.859061 13.661040 -17.687912 402 3517 3518 + 3517 H -22.818174 13.783386 -16.772102 403 3516 + 3518 H -23.770832 13.543351 -17.918472 403 3516 + 3519 O 9.494782 -11.734449 -13.112549 402 3520 3521 + 3520 H 8.961400 -12.465267 -13.446468 403 3519 + 3521 H 9.761388 -11.207603 -13.875868 403 3519 + 3522 O -23.688259 3.132799 -17.827915 402 3523 3524 + 3523 H -24.125760 3.978960 -17.963214 403 3522 + 3524 H -22.830341 3.138251 -18.271402 403 3522 + 3525 O 2.139153 19.832776 -5.462308 402 3526 3527 + 3526 H 3.092901 19.927439 -5.794969 403 3525 + 3527 H 1.766619 18.977669 -5.658347 403 3525 + 3528 O -18.034230 16.770127 14.099225 402 3529 3530 + 3529 H -17.902225 17.120236 14.993829 403 3528 + 3530 H -17.676323 15.854045 14.106616 403 3528 + 3531 O 1.824513 11.181132 6.084313 402 3532 3533 + 3532 H 1.685221 10.344866 6.529341 403 3531 + 3533 H 1.455718 11.848001 6.661967 403 3531 + 3534 O -11.843291 -5.056449 -16.641604 402 3535 3536 + 3535 H -12.501020 -5.242103 -17.328702 403 3534 + 3536 H -12.014281 -5.753377 -15.968200 403 3534 + 3537 O -22.854164 5.542584 7.008128 402 3538 3539 + 3538 H -23.145262 4.706955 7.372586 403 3537 + 3539 H -23.371620 6.215233 7.454255 403 3537 + 3540 O 15.073774 -20.411976 -0.392431 402 3541 3542 + 3541 H 14.408322 -20.469017 0.286083 403 3540 + 3542 H 14.632572 -19.889979 -1.049199 403 3540 + 3543 O -17.960070 -5.852749 5.689988 402 3544 3545 + 3544 H -18.090795 -5.039390 5.186397 403 3543 + 3545 H -18.353234 -5.775538 6.579834 403 3543 + 3546 O -15.352248 -19.036717 0.344261 402 3547 3548 + 3547 H -15.093308 -18.197320 -0.050384 403 3546 + 3548 H -15.225898 -18.950231 1.302869 403 3546 + 3549 O 18.470960 -18.740483 5.244443 402 3550 3551 + 3550 H 18.242618 -17.821184 5.079689 403 3549 + 3551 H 19.343394 -18.632602 5.657266 403 3549 + 3552 O -20.494949 -15.508798 0.415196 402 3553 3554 + 3553 H -21.033257 -14.800381 0.873351 403 3552 + 3554 H -20.631551 -16.381502 0.919462 403 3552 + 3555 O -26.836213 -15.820962 -1.291434 402 3556 3557 + 3556 H -25.922353 -15.963173 -1.047747 403 3555 + 3557 H -27.438259 -16.224400 -0.574562 403 3555 + 3558 O -13.235942 4.403119 -11.675233 402 3559 3560 + 3559 H -12.394934 3.955397 -11.762629 403 3558 + 3560 H -13.370313 4.660640 -10.729304 403 3558 + 3561 O 4.457457 8.304220 -12.786971 402 3562 3563 + 3562 H 3.724242 8.788507 -13.141101 403 3561 + 3563 H 4.902410 9.007385 -12.278991 403 3561 + 3564 O 12.905103 9.611740 -9.761522 402 3565 3566 + 3565 H 12.523788 8.903277 -10.260068 403 3564 + 3566 H 13.450668 9.299611 -9.028515 403 3564 + 3567 O -6.337643 16.236433 1.452793 402 3568 3569 + 3568 H -5.424381 16.339480 1.573225 403 3567 + 3569 H -6.667968 16.644895 2.291271 403 3567 + 3570 O 26.439116 -1.915810 -20.713552 402 3571 3572 + 3571 H 27.188632 -1.287536 -20.817388 403 3570 + 3572 H 26.782485 -2.730706 -20.995261 403 3570 + 3573 O -19.182622 4.092355 9.034920 402 3574 3575 + 3574 H -19.485362 4.670885 8.308243 403 3573 + 3575 H -20.013187 3.814515 9.521856 403 3573 + 3576 O -2.300541 3.557512 -14.043398 402 3577 3578 + 3577 H -1.431422 3.599599 -13.555115 403 3576 + 3578 H -1.988145 3.224630 -14.961052 403 3576 + 3579 O -6.670819 -15.218721 -14.514642 402 3580 3581 + 3580 H -6.017795 -15.980959 -14.424699 403 3579 + 3581 H -6.265671 -14.423752 -14.172913 403 3579 + 3582 O 24.507006 4.960415 18.725868 402 3583 3584 + 3583 H 24.051892 4.202462 19.172938 403 3582 + 3584 H 23.940639 5.744203 18.851669 403 3582 + 3585 O 24.049293 12.473043 -13.141226 402 3586 3587 + 3586 H 23.243912 12.962673 -12.967339 403 3585 + 3587 H 23.840443 11.608716 -13.489633 403 3585 + 3588 O -14.826342 -14.174711 -1.101280 402 3589 3590 + 3589 H -14.425942 -14.926791 -0.673989 403 3588 + 3590 H -15.768151 -14.488595 -1.118329 403 3588 + 3591 O 11.933486 13.553808 -14.961215 402 3592 3593 + 3592 H 11.036396 13.817670 -14.752407 403 3591 + 3593 H 12.216429 12.950104 -14.279104 403 3591 + 3594 O -2.797562 -12.367574 -0.515800 402 3595 3596 + 3595 H -3.179634 -11.713519 0.050158 403 3594 + 3596 H -1.854871 -12.532942 -0.270880 403 3594 + 3597 O 17.488207 19.028545 -2.724709 402 3598 3599 + 3598 H 17.501182 19.646316 -1.945319 403 3597 + 3599 H 17.260989 19.579570 -3.517708 403 3597 + 3600 O -8.757369 -14.229883 -8.206010 402 3601 3602 + 3601 H -8.893000 -13.537739 -8.862015 403 3600 + 3602 H -9.392123 -14.135387 -7.486682 403 3600 + 3603 O -19.153579 -12.365172 5.625409 402 3604 3605 + 3604 H -19.433383 -12.590110 4.725475 403 3603 + 3605 H -19.595557 -11.555979 5.869535 403 3603 + 3606 O -7.701926 -16.135625 -11.737971 402 3607 3608 + 3607 H -6.868196 -16.044745 -12.240387 403 3606 + 3608 H -8.301809 -15.535544 -12.265120 403 3606 + 3609 O -3.605808 12.358960 20.023921 402 3610 3611 + 3610 H -4.119307 12.832959 19.358309 403 3609 + 3611 H -4.145218 11.656406 20.372183 403 3609 + 3612 O -13.013980 18.377636 -12.951904 402 3613 3614 + 3613 H -12.288179 17.997337 -13.504982 403 3612 + 3614 H -12.538318 18.992103 -12.385350 403 3612 + 3615 O -1.385735 6.480272 7.505236 402 3616 3617 + 3616 H -1.829939 5.594981 7.333987 403 3615 + 3617 H -1.326794 6.575998 8.446333 403 3615 + 3618 O 9.907861 10.609361 -15.151767 402 3619 3620 + 3619 H 10.299023 10.375476 -14.276851 403 3618 + 3620 H 9.651161 11.529891 -14.985274 403 3618 + 3621 O 9.310538 -2.514250 -12.134416 402 3622 3623 + 3622 H 10.198177 -2.553660 -11.653872 403 3621 + 3623 H 8.836792 -1.753472 -11.726830 403 3621 + 3624 O -21.580142 4.778390 0.032360 402 3625 3626 + 3625 H -21.344591 5.531473 -0.492439 403 3624 + 3626 H -20.893065 4.098475 -0.015753 403 3624 + 3627 O -19.278441 10.667329 -7.670184 402 3628 3629 + 3628 H -19.734646 10.867025 -6.871193 403 3627 + 3629 H -18.532328 10.061861 -7.412248 403 3627 + 3630 O 15.203902 17.401580 19.186703 402 3631 3632 + 3631 H 15.570898 16.998223 18.309293 403 3630 + 3632 H 14.252264 17.471997 19.020983 403 3630 + 3633 O 17.475659 -4.241820 15.422666 402 3634 3635 + 3634 H 17.040898 -4.071975 16.320909 403 3633 + 3635 H 18.352897 -4.517345 15.720235 403 3633 + 3636 O 26.262986 8.204965 -20.205701 402 3637 3638 + 3637 H 26.293506 8.464866 -19.242230 403 3636 + 3638 H 25.312183 8.095575 -20.318886 403 3636 + 3639 O 0.327844 9.896832 15.417356 402 3640 3641 + 3640 H 1.202524 9.685899 15.170065 403 3639 + 3641 H -0.168717 9.349803 14.747140 403 3639 + 3642 O 13.450972 -1.248355 9.296159 402 3643 3644 + 3643 H 12.530981 -1.651940 9.252801 403 3642 + 3644 H 13.953341 -1.912001 9.787602 403 3642 + 3645 O -5.429467 -15.995612 -8.899753 402 3646 3647 + 3646 H -4.916725 -16.325409 -8.062672 403 3645 + 3647 H -6.362549 -16.264748 -8.759990 403 3645 + 3648 O -17.910357 -1.868084 -15.474085 402 3649 3650 + 3649 H -18.801800 -2.365773 -15.300107 403 3648 + 3650 H -17.939036 -0.883951 -15.233581 403 3648 + 3651 O -6.998449 17.854546 12.155260 402 3652 3653 + 3652 H -7.324766 18.684261 11.705842 403 3651 + 3653 H -7.250338 17.940958 13.056006 403 3651 + 3654 O -27.017579 -12.852914 -7.744953 402 3655 3656 + 3655 H -26.095216 -13.088941 -7.541719 403 3654 + 3656 H -27.046015 -11.903607 -7.742366 403 3654 + 3657 O -20.992952 2.770137 13.223137 402 3658 3659 + 3658 H -21.230776 2.404263 14.087077 403 3657 + 3659 H -20.235470 2.326081 12.930982 403 3657 + 3660 O -26.544599 -5.877011 11.453664 402 3661 3662 + 3661 H -26.990332 -6.544246 10.916058 403 3660 + 3662 H -26.022394 -5.435999 10.830265 403 3660 + 3663 O -18.806379 11.367507 -13.046200 402 3664 3665 + 3664 H -19.789015 11.313553 -13.067429 403 3663 + 3665 H -18.628129 11.249318 -14.024506 403 3663 + 3666 O 24.794642 -2.429791 16.906929 402 3667 3668 + 3667 H 24.375084 -1.564983 16.998802 403 3666 + 3668 H 24.946627 -2.558178 15.958491 403 3666 + 3669 O -5.039569 8.056593 -19.064906 402 3670 3671 + 3670 H -5.052461 7.958795 -18.117466 403 3669 + 3671 H -5.966890 7.849304 -19.446709 403 3669 + 3672 O -2.889572 19.346856 10.223639 402 3673 3674 + 3673 H -3.384312 19.390763 9.401856 403 3672 + 3674 H -2.683383 20.308050 10.287170 403 3672 + 3675 O 24.834396 15.890694 6.130456 402 3676 3677 + 3676 H 24.234322 16.328808 6.788069 403 3675 + 3677 H 24.458399 16.070054 5.248361 403 3675 + 3678 O -5.675815 -18.202610 8.635402 402 3679 3680 + 3679 H -5.773224 -18.994730 9.253066 403 3678 + 3680 H -6.566693 -17.951332 8.462469 403 3678 + 3681 O 0.200228 10.638735 -9.720146 402 3682 3683 + 3682 H 1.124053 10.363079 -9.765946 403 3681 + 3683 H -0.169388 10.758518 -8.862327 403 3681 + 3684 O 12.586551 -8.995486 13.235948 402 3685 3686 + 3685 H 11.738414 -8.465169 13.179917 403 3684 + 3686 H 13.275714 -8.448558 12.911108 403 3684 + 3687 O 21.728995 -9.340509 14.117203 402 3688 3689 + 3688 H 21.166035 -8.543859 14.159733 403 3687 + 3689 H 21.300249 -10.103143 14.587027 403 3687 + 3690 O -6.837755 -7.061822 -14.579566 402 3691 3692 + 3691 H -7.451539 -6.737549 -13.910594 403 3690 + 3692 H -7.310401 -7.496795 -15.364575 403 3690 + 3693 O -9.354286 -10.670675 -5.815047 402 3694 3695 + 3694 H -9.142443 -9.961054 -6.416990 403 3693 + 3695 H -10.107132 -10.315463 -5.251791 403 3693 + 3696 O -8.705352 0.316369 14.356920 402 3697 3698 + 3697 H -8.755318 1.248673 14.182151 403 3696 + 3698 H -7.817961 -0.022395 14.313721 403 3696 + 3699 O 14.343736 18.982116 -1.699643 402 3700 3701 + 3700 H 14.409424 19.286931 -2.586247 403 3699 + 3701 H 14.592964 19.709765 -1.190359 403 3699 + 3702 O 14.559527 1.138316 10.218417 402 3703 3704 + 3703 H 15.479051 1.159830 9.856479 403 3702 + 3704 H 14.063855 0.416501 9.816078 403 3702 + 3705 O -20.566241 -0.996254 13.005878 402 3706 3707 + 3706 H -20.899331 -1.479928 12.209922 403 3705 + 3707 H -20.624473 -1.700653 13.673656 403 3705 + 3708 O -12.852778 -16.278261 -7.915385 402 3709 3710 + 3709 H -13.264438 -16.542888 -8.750067 403 3708 + 3710 H -12.112512 -16.948829 -7.782415 403 3708 + 3711 O -25.785944 -19.319619 -1.839096 402 3712 3713 + 3712 H -26.458799 -18.855500 -2.342721 403 3711 + 3713 H -25.985807 -19.145409 -0.929325 403 3711 + 3714 O -10.186107 18.619821 1.502896 402 3715 3716 + 3715 H -10.024101 19.020438 2.390188 403 3714 + 3716 H -10.942245 19.107400 1.164289 403 3714 + 3717 O 4.484858 10.819107 -17.964431 402 3718 3719 + 3718 H 5.133939 11.386899 -18.298672 403 3717 + 3719 H 4.527691 10.727124 -17.013873 403 3717 + 3720 O 6.463933 -18.890881 -12.906574 402 3721 3722 + 3721 H 7.142489 -18.893949 -12.181472 403 3720 + 3722 H 6.490763 -19.813219 -13.109192 403 3720 + 3723 O -15.198788 -16.766626 -9.336110 402 3724 3725 + 3724 H -15.377180 -16.563167 -8.461513 403 3723 + 3725 H -15.323254 -15.974257 -9.877497 403 3723 + 3726 O -14.146010 -20.422548 8.878122 402 3727 3728 + 3727 H -14.236979 -20.532175 7.917793 403 3726 + 3728 H -13.662828 -21.215449 9.131232 403 3726 + 3729 O 0.614957 1.428020 12.956126 402 3730 3731 + 3730 H -0.110540 1.901658 12.528670 403 3729 + 3731 H 0.325279 0.716474 13.497208 403 3729 + 3732 O -22.321257 -12.194484 -18.427855 402 3733 3734 + 3733 H -22.696325 -13.106322 -18.375252 403 3732 + 3734 H -22.412389 -11.917225 -19.335761 403 3732 + 3735 O 12.531442 -4.758462 20.472899 402 3736 3737 + 3736 H 13.067534 -4.753926 21.307738 403 3735 + 3737 H 12.096556 -5.562360 20.454035 403 3735 + 3738 O 13.892356 14.515119 -17.220006 402 3739 3740 + 3739 H 13.491013 15.249793 -17.676248 403 3738 + 3740 H 14.027899 14.819402 -16.306112 403 3738 + 3741 O 17.502120 -14.847049 -15.435947 402 3742 3743 + 3742 H 17.364472 -13.948352 -15.811879 403 3741 + 3743 H 18.105027 -15.359005 -16.059699 403 3741 + 3744 O -0.502268 9.530205 -15.562269 402 3745 3746 + 3745 H -0.938753 10.373293 -15.281955 403 3744 + 3746 H -0.097702 9.138998 -14.755615 403 3744 + 3747 O -21.309309 -20.408905 -16.987522 402 3748 3749 + 3748 H -21.345337 -20.375840 -17.999142 403 3747 + 3749 H -22.141862 -20.762308 -16.688786 403 3747 + 3750 O 22.147493 -6.639909 2.885000 402 3751 3752 + 3751 H 22.188652 -7.549798 2.578098 403 3750 + 3752 H 22.107229 -6.728348 3.871637 403 3750 + 3753 O -9.687279 5.414380 15.613331 402 3754 3755 + 3754 H -9.782742 5.066486 16.529208 403 3753 + 3755 H -10.448969 5.923644 15.361474 403 3753 + 3756 O 5.675344 7.586899 16.980957 402 3757 3758 + 3757 H 5.258959 7.810456 16.122506 403 3756 + 3758 H 6.513311 8.070410 16.991766 403 3756 + 3759 O -20.413973 -2.810756 -14.704675 402 3760 3761 + 3760 H -20.680710 -3.455276 -14.087899 403 3759 + 3761 H -20.927913 -2.006038 -14.605374 403 3759 + 3762 O -22.235897 -8.299273 -7.619662 402 3763 3764 + 3763 H -22.889194 -7.882281 -8.261122 403 3762 + 3764 H -22.332627 -7.861076 -6.765324 403 3762 + 3765 O -23.981218 -0.704780 -9.514827 402 3766 3767 + 3766 H -24.783483 -0.715849 -8.978342 403 3765 + 3767 H -24.016239 0.147898 -9.927153 403 3765 + 3768 O 7.651613 1.583143 -14.760840 402 3769 3770 + 3769 H 8.495812 1.439050 -15.299970 403 3768 + 3770 H 7.511620 2.516131 -14.862425 403 3768 + 3771 O 0.884173 -19.810112 -4.062624 402 3772 3773 + 3772 H 1.292889 -20.586437 -4.551786 403 3771 + 3773 H 1.192078 -19.022801 -4.536111 403 3771 + 3774 O 7.412040 11.115702 19.231433 402 3775 3776 + 3775 H 7.538580 12.059258 19.246795 403 3774 + 3776 H 8.260401 10.691591 19.301522 403 3774 + 3777 O -11.204219 12.495567 -4.600276 402 3778 3779 + 3778 H -11.028750 12.509428 -5.556334 403 3777 + 3779 H -10.363635 12.791820 -4.218009 403 3777 + 3780 O -25.903206 -8.385161 -5.723268 402 3781 3782 + 3781 H -25.119970 -7.920015 -6.092411 403 3780 + 3782 H -25.526651 -8.874179 -5.022568 403 3780 + 3783 O 14.802024 4.590987 3.933454 402 3784 3785 + 3784 H 14.375737 4.043905 3.277970 403 3783 + 3785 H 15.659394 4.916121 3.578549 403 3783 + 3786 O -15.934931 6.397950 6.388644 402 3787 3788 + 3787 H -15.620802 7.216906 6.047813 403 3786 + 3788 H -15.636175 5.690485 5.842853 403 3786 + 3789 O 22.212269 -3.912264 -1.134049 402 3790 3791 + 3790 H 22.458591 -3.040474 -1.407870 403 3789 + 3791 H 22.479085 -3.998208 -0.233468 403 3789 + 3792 O 4.448770 -18.623307 6.143091 402 3793 3794 + 3793 H 3.859811 -18.031485 6.593889 403 3792 + 3794 H 4.151476 -19.464236 6.536017 403 3792 + 3795 O 12.429816 -18.121512 9.248186 402 3796 3797 + 3796 H 11.629942 -18.388099 8.814270 403 3795 + 3797 H 12.215561 -17.727680 10.120763 403 3795 + 3798 O -8.497823 15.258872 16.966673 402 3799 3800 + 3799 H -7.810852 14.986731 16.348784 403 3798 + 3800 H -8.167882 16.114306 17.249722 403 3798 + 3801 O -20.878291 -14.745638 19.779655 402 3802 3803 + 3802 H -20.112590 -15.386225 19.796245 403 3801 + 3803 H -20.957585 -14.429386 20.699068 403 3801 + 3804 O -8.042069 13.212107 -6.799126 402 3805 3806 + 3805 H -7.666844 14.065367 -7.020588 403 3804 + 3806 H -8.432360 12.994260 -7.617112 403 3804 + 3807 O -4.401745 18.792233 12.536049 402 3808 3809 + 3808 H -5.252264 18.441661 12.206342 403 3807 + 3809 H -3.786314 18.658531 11.783750 403 3807 + 3810 O -22.502948 12.635671 -9.954592 402 3811 3812 + 3811 H -22.382976 11.654218 -10.023557 403 3810 + 3812 H -22.588936 12.849370 -9.051340 403 3810 + 3813 O 6.205019 19.677761 10.016183 402 3814 3815 + 3814 H 6.418256 20.244108 9.256973 403 3813 + 3815 H 6.081289 20.311217 10.773751 403 3813 + 3816 O 21.525435 -20.385383 2.444412 402 3817 3818 + 3817 H 21.737318 -20.408572 1.494251 403 3816 + 3818 H 22.084053 -21.109629 2.761837 403 3816 + 3819 O -16.599942 -18.820535 17.198669 402 3820 3821 + 3820 H -16.278472 -18.736077 16.290240 403 3819 + 3821 H -16.380933 -19.763878 17.294110 403 3819 + 3822 O -25.290808 -16.946358 -19.688799 402 3823 3824 + 3823 H -24.765600 -16.889073 -18.911085 403 3822 + 3824 H -25.960541 -16.377910 -19.456590 403 3822 + 3825 O -24.694098 -20.476906 -4.136770 402 3826 3827 + 3826 H -24.606655 -20.536372 -5.117234 403 3825 + 3827 H -25.625806 -20.119370 -3.878957 403 3825 + 3828 O 11.896824 11.712030 16.306177 402 3829 3830 + 3829 H 11.348704 12.251154 16.873688 403 3828 + 3830 H 11.274914 11.545841 15.498058 403 3828 + 3831 O 5.697623 16.972820 10.470297 402 3832 3833 + 3832 H 4.991770 17.170798 11.097893 403 3831 + 3833 H 5.852878 17.817924 10.052784 403 3831 + 3834 O -13.284850 -7.746454 -6.025360 402 3835 3836 + 3835 H -12.994189 -6.883337 -5.651840 403 3834 + 3836 H -13.328473 -7.609512 -6.952585 403 3834 + 3837 O -21.223162 1.160412 -11.807882 402 3838 3839 + 3838 H -22.146291 1.276713 -11.566889 403 3837 + 3839 H -20.896068 1.043394 -10.863664 403 3837 + 3840 O -4.631057 18.622729 -4.921244 402 3841 3842 + 3841 H -4.887844 18.863646 -4.031199 403 3840 + 3842 H -5.230286 17.969756 -5.219284 403 3840 + 3843 O 24.681797 -17.654294 -1.670971 402 3844 3845 + 3844 H 23.768274 -17.475294 -1.329114 403 3843 + 3845 H 24.791039 -18.602540 -1.565321 403 3843 + 3846 O -17.687536 -19.879421 -18.679576 402 3847 3848 + 3847 H -17.986562 -20.092647 -17.773622 403 3846 + 3848 H -17.222303 -20.676328 -18.924760 403 3846 + 3849 O -6.573668 -1.414933 -12.940464 402 3850 3851 + 3850 H -5.981594 -0.685726 -13.202528 403 3849 + 3851 H -7.313339 -1.430989 -13.600227 403 3849 + 3852 O 24.852405 8.745112 16.566019 402 3853 3854 + 3853 H 25.315387 9.320408 17.189845 403 3852 + 3854 H 25.373490 7.938156 16.494188 403 3852 + 3855 O 19.231159 -18.894566 -9.451949 402 3856 3857 + 3856 H 18.429507 -18.461081 -9.748217 403 3855 + 3857 H 18.920766 -19.499725 -8.784679 403 3855 + 3858 O 3.338073 -20.229490 -19.454945 402 3859 3860 + 3859 H 2.656040 -19.781393 -18.876483 403 3858 + 3860 H 4.028693 -19.592026 -19.519704 403 3858 + 3861 O 10.225819 20.337141 12.829025 402 3862 3863 + 3862 H 9.563839 20.833795 13.325284 403 3861 + 3863 H 9.705679 19.640109 12.367009 403 3861 + 3864 O 9.533934 0.668964 -16.571520 402 3865 3866 + 3865 H 10.399193 0.538209 -16.091711 403 3864 + 3866 H 9.576351 1.385138 -17.298275 403 3864 + 3867 O 10.662383 -1.197996 9.643694 402 3868 3869 + 3868 H 10.669217 -0.519470 10.302977 403 3867 + 3869 H 9.975986 -0.906856 8.995989 403 3867 + 3870 O -8.631045 -16.685206 -9.233119 402 3871 3872 + 3871 H -8.853335 -15.836492 -8.694578 403 3870 + 3872 H -8.361803 -16.344073 -10.088388 403 3870 + 3873 O -16.046867 3.202795 -18.808362 402 3874 3875 + 3874 H -16.950450 3.324347 -19.009457 403 3873 + 3875 H -16.106623 2.648826 -18.004784 403 3873 + 3876 O -21.655953 -18.268305 -5.022876 402 3877 3878 + 3877 H -22.220521 -18.292491 -4.188932 403 3876 + 3878 H -21.437192 -17.347868 -5.235461 403 3876 + 3879 O -3.054479 -8.582825 -16.474970 402 3880 3881 + 3880 H -3.561388 -8.760643 -15.715699 403 3879 + 3881 H -3.058659 -7.559442 -16.547327 403 3879 + 3882 O -22.812267 -16.888527 -8.744475 402 3883 3884 + 3883 H -22.235942 -16.090582 -8.825879 403 3882 + 3884 H -23.719738 -16.520887 -8.878128 403 3882 + 3885 O -3.704190 -14.195133 -2.407699 402 3886 3887 + 3886 H -3.387102 -14.174810 -3.288821 403 3885 + 3887 H -3.356349 -13.453995 -1.933962 403 3885 + 3888 O -20.696165 -13.591009 17.258237 402 3889 3890 + 3889 H -21.475297 -13.153296 16.960866 403 3888 + 3890 H -20.768473 -13.524910 18.211894 403 3888 + 3891 O -18.077515 8.036142 -4.047377 402 3892 3893 + 3892 H -17.812789 8.648744 -4.737838 403 3891 + 3893 H -17.620887 8.520879 -3.289746 403 3891 + 3894 O -20.110600 19.407267 6.124785 402 3895 3896 + 3895 H -20.896902 18.868688 6.157232 403 3894 + 3896 H -20.402600 20.334320 6.077069 403 3894 + 3897 O -2.051195 9.467924 7.827905 402 3898 3899 + 3898 H -2.097838 10.162479 7.064246 403 3897 + 3899 H -2.844983 9.344092 8.305687 403 3897 + 3900 O -18.682154 5.478699 -2.934427 402 3901 3902 + 3901 H -18.229636 5.442492 -2.124369 403 3900 + 3902 H -18.518659 6.286464 -3.381696 403 3900 + 3903 O 10.010203 14.447632 13.470001 402 3904 3905 + 3904 H 10.226696 15.357421 13.799091 403 3903 + 3905 H 9.262668 14.599091 12.884669 403 3903 + 3906 O 17.215836 -17.548329 -2.124086 402 3907 3908 + 3907 H 16.925189 -16.662250 -2.252230 403 3906 + 3908 H 16.865887 -17.769074 -1.235796 403 3906 + 3909 O -5.919183 -9.349524 7.766171 402 3910 3911 + 3910 H -6.741218 -8.869400 7.859192 403 3909 + 3911 H -5.404573 -8.951408 7.082536 403 3909 + 3912 O -10.112774 -17.514245 5.470012 402 3913 3914 + 3913 H -10.177248 -17.335797 6.413035 403 3912 + 3914 H -10.903396 -17.912916 5.176788 403 3912 + 3915 O -17.679442 -12.718669 -9.050443 402 3916 3917 + 3916 H -18.270476 -12.557016 -8.300034 403 3915 + 3917 H -18.198469 -12.552825 -9.805697 403 3915 + 3918 O 0.903259 -17.089060 -20.671596 402 3919 3920 + 3919 H 1.071535 -16.725461 -21.579419 403 3918 + 3920 H 1.485989 -16.556142 -20.071022 403 3918 + 3921 O -1.956506 2.203046 13.006137 402 3922 3923 + 3922 H -2.272231 1.835920 13.818085 403 3921 + 3923 H -1.592679 3.074581 13.177858 403 3921 + 3924 O 24.307317 -7.931160 13.942533 402 3925 3926 + 3925 H 23.816648 -8.756525 14.130421 403 3924 + 3926 H 25.262169 -8.082231 14.204005 403 3924 + 3927 O -14.058968 19.300765 0.314297 402 3928 3929 + 3928 H -13.917031 18.387642 0.266006 403 3927 + 3929 H -13.221511 19.754514 0.415523 403 3927 + 3930 O -16.676872 -9.877858 -20.319129 402 3931 3932 + 3931 H -17.274810 -10.519927 -20.729021 403 3930 + 3932 H -16.941519 -8.964879 -20.646570 403 3930 + 3933 O -12.680702 -6.911233 16.978199 402 3934 3935 + 3934 H -13.557850 -6.922758 17.425905 403 3933 + 3935 H -12.269134 -7.738029 17.145620 403 3933 + 3936 O 19.555509 -17.579926 -19.976313 402 3937 3938 + 3937 H 19.050335 -18.389167 -19.640518 403 3936 + 3938 H 18.949443 -17.119931 -20.527020 403 3936 + 3939 O 21.076471 3.084534 14.949703 402 3940 3941 + 3940 H 21.982711 3.424585 15.137726 403 3939 + 3941 H 21.059338 2.943234 13.989445 403 3939 + 3942 O 16.442213 12.147725 -13.378964 402 3943 3944 + 3943 H 16.950297 12.610197 -12.695317 403 3942 + 3944 H 15.827762 12.795203 -13.746701 403 3942 + 3945 O -25.439902 4.711302 -20.157995 402 3946 3947 + 3946 H -25.232468 3.814757 -20.523590 403 3945 + 3947 H -26.313293 4.971364 -20.426324 403 3945 + 3948 O -7.588528 12.088664 13.408162 402 3949 3950 + 3949 H -8.200423 12.174754 12.658025 403 3948 + 3950 H -8.113691 11.630720 14.142990 403 3948 + 3951 O 26.436785 0.034911 5.586573 402 3952 3953 + 3952 H 25.457878 0.386547 5.643112 403 3951 + 3953 H 26.282513 -0.892272 5.901143 403 3951 + 3954 O 20.823937 -7.100912 -0.564869 402 3955 3956 + 3955 H 20.884805 -6.179294 -0.203608 403 3954 + 3956 H 21.513466 -7.607628 -0.095760 403 3954 + 3957 O 12.691400 17.480587 1.380786 402 3958 3959 + 3958 H 12.692396 17.261428 2.322353 403 3957 + 3959 H 12.611923 16.651984 0.923905 403 3957 + 3960 O -24.911725 10.197954 8.411953 402 3961 3962 + 3961 H -25.636701 10.762551 8.096402 403 3960 + 3962 H -25.071847 10.060147 9.332683 403 3960 + 3963 O -18.639378 5.447813 -18.001661 402 3964 3965 + 3964 H -18.974361 6.320483 -18.277153 403 3963 + 3965 H -17.987263 5.631149 -17.283273 403 3963 + 3966 O -20.959865 -1.961151 19.496385 402 3967 3968 + 3967 H -20.534023 -2.468481 20.215248 403 3966 + 3968 H -20.355179 -1.361709 19.053432 403 3966 + 3969 O 25.098062 -12.896695 17.002170 402 3970 3971 + 3970 H 24.406639 -13.455503 17.206622 403 3969 + 3971 H 24.932322 -12.540708 16.110034 403 3969 + 3972 O -26.490917 -20.588542 6.528398 402 3973 3974 + 3973 H -26.917008 -20.096913 5.823633 403 3972 + 3974 H -25.946103 -19.813146 6.884354 403 3972 + 3975 O 18.663882 -15.761448 0.434559 402 3976 3977 + 3976 H 18.293356 -16.602715 0.618971 403 3975 + 3977 H 18.164755 -15.050245 0.892557 403 3975 + 3978 O 10.988074 -12.207500 15.456319 402 3979 3980 + 3979 H 11.659991 -12.535619 14.945024 403 3978 + 3980 H 11.316489 -11.864883 16.268157 403 3978 + 3981 O -21.505805 3.757682 10.585783 402 3982 3983 + 3982 H -21.516645 3.500786 11.561155 403 3981 + 3983 H -21.430683 4.736521 10.599986 403 3981 + 3984 O 12.282284 -13.106227 -18.881930 402 3985 3986 + 3985 H 12.759593 -12.281589 -18.973554 403 3984 + 3986 H 11.656222 -12.946682 -18.168338 403 3984 + 3987 O 13.087944 10.285301 -0.892868 402 3988 3989 + 3988 H 13.800763 10.058844 -0.348329 403 3987 + 3989 H 13.444993 10.532975 -1.717057 403 3987 + 3990 O -9.162139 -11.933739 -19.558277 402 3991 3992 + 3991 H -8.651549 -11.246835 -19.197918 403 3990 + 3992 H -8.816392 -12.749175 -19.109531 403 3990 + 3993 O -13.431343 12.125781 14.789987 402 3994 3995 + 3994 H -14.177333 12.077783 15.386597 403 3993 + 3995 H -13.089871 13.025037 14.836795 403 3993 + 3996 O 18.177368 7.215321 -17.740007 402 3997 3998 + 3997 H 17.389540 7.853045 -17.679076 403 3996 + 3998 H 17.843221 6.367105 -17.888163 403 3996 + 3999 O 1.466167 -13.601298 7.582198 402 4000 4001 + 4000 H 0.972435 -14.385853 7.776388 403 3999 + 4001 H 0.919057 -12.873156 7.164133 403 3999 + 4002 O 11.325663 12.317782 -17.859494 402 4003 4004 + 4003 H 11.786996 12.918180 -17.243704 403 4002 + 4004 H 11.714407 11.538450 -17.534509 403 4002 + 4005 O 17.972713 -1.451543 -17.483151 402 4006 4007 + 4006 H 18.207855 -0.912662 -18.203981 403 4005 + 4007 H 17.842338 -0.769611 -16.779012 403 4005 + 4008 O 25.598333 7.442585 -7.896359 402 4009 4010 + 4009 H 25.893540 7.973241 -8.686847 403 4008 + 4010 H 24.662621 7.579298 -7.748832 403 4008 + 4011 O 16.953262 -5.516556 7.796955 402 4012 4013 + 4012 H 16.150883 -6.127947 7.920888 403 4011 + 4013 H 16.872953 -4.676742 8.219748 403 4011 + 4014 O 12.447806 -2.742404 -5.103683 402 4015 4016 + 4015 H 13.262065 -2.337192 -4.865615 403 4014 + 4016 H 12.567802 -3.638206 -5.489980 403 4014 + 4017 O 23.442824 1.912863 -4.186751 402 4018 4019 + 4018 H 22.783687 1.609227 -4.831788 403 4017 + 4019 H 23.692291 2.783304 -4.548967 403 4017 + 4020 O 26.613065 -7.057291 -2.847144 402 4021 4022 + 4021 H 25.921057 -6.884909 -2.189136 403 4020 + 4022 H 26.624480 -6.286981 -3.475448 403 4020 + 4023 O -10.239445 -6.332791 -18.742073 402 4024 4025 + 4024 H -10.340169 -5.647767 -18.098924 403 4023 + 4025 H -10.090969 -5.968696 -19.646250 403 4023 + 4026 O -20.376403 -6.492157 -15.200035 402 4027 4028 + 4027 H -21.216096 -6.709010 -14.741818 403 4026 + 4028 H -19.747585 -6.443291 -14.454302 403 4026 + 4029 O 12.425316 -12.073259 9.372568 402 4030 4031 + 4030 H 12.595386 -11.730652 10.279050 403 4029 + 4031 H 11.975580 -11.375801 8.874658 403 4029 + 4032 O -8.532199 -0.531892 16.952480 402 4033 4034 + 4033 H -8.680978 0.164546 17.584693 403 4032 + 4034 H -8.601294 -0.093174 16.091071 403 4032 + 4035 O -15.814683 -10.863297 -17.898155 402 4036 4037 + 4036 H -15.883461 -10.639190 -18.879894 403 4035 + 4037 H -16.703278 -10.849248 -17.497731 403 4035 + 4038 O -14.449801 9.759702 -12.925291 402 4039 4040 + 4039 H -14.272437 8.788361 -12.976539 403 4038 + 4040 H -15.016657 9.891030 -12.180657 403 4038 + 4041 O -21.430732 11.921106 -19.181002 402 4042 4043 + 4042 H -21.526880 12.138660 -20.109451 403 4041 + 4043 H -22.050688 12.479567 -18.617821 403 4041 + 4044 O -25.974066 -3.158098 2.462777 402 4045 4046 + 4045 H -25.831369 -2.255405 2.174801 403 4044 + 4046 H -26.439926 -3.064742 3.263507 403 4044 + 4047 O -3.706735 6.147388 -13.605663 402 4048 4049 + 4048 H -3.297323 5.307884 -13.886877 403 4047 + 4049 H -3.422860 6.737980 -14.321183 403 4047 + 4050 O -20.883597 16.612287 14.041958 402 4051 4052 + 4051 H -20.999564 17.543929 13.958831 403 4050 + 4052 H -19.965627 16.487176 14.039107 403 4050 + 4053 O -20.557889 -1.845471 7.488592 402 4054 4055 + 4054 H -20.340337 -1.068424 6.935483 403 4053 + 4055 H -20.903185 -2.604394 7.012639 403 4053 + 4056 O -12.460264 -18.929249 4.382660 402 4057 4058 + 4057 H -12.282133 -18.769615 3.435033 403 4056 + 4058 H -13.389343 -18.666156 4.432821 403 4056 + 4059 O 1.417248 11.708889 10.582961 402 4060 4061 + 4060 H 2.296023 11.794703 10.114913 403 4059 + 4061 H 1.322165 12.680869 10.895877 403 4059 + 4062 O 10.022181 17.152306 -1.509079 402 4063 4064 + 4063 H 9.099220 16.788088 -1.473811 403 4062 + 4064 H 10.556572 16.462293 -1.005697 403 4062 + 4065 O 26.377298 1.167852 -18.114945 402 4066 4067 + 4066 H 26.294922 1.597527 -19.017371 403 4065 + 4067 H 26.810582 1.835218 -17.546811 403 4065 + 4068 O 4.477282 16.231872 -2.892567 402 4069 4070 + 4069 H 4.601255 15.878653 -3.817385 403 4068 + 4070 H 5.378487 16.115183 -2.438618 403 4068 + 4071 O 24.364511 -2.064551 14.086212 402 4072 4073 + 4072 H 24.217903 -1.193238 13.665466 403 4071 + 4073 H 25.144037 -2.400521 13.646565 403 4071 + 4074 O 19.972396 19.003953 10.129446 402 4075 4076 + 4075 H 19.099910 19.391464 10.278245 403 4074 + 4076 H 20.140306 18.289889 10.813702 403 4074 + 4077 O -9.744468 15.055459 -16.611544 402 4078 4079 + 4078 H -10.467454 15.614656 -16.286228 403 4077 + 4079 H -10.073803 14.402676 -17.210684 403 4077 + 4080 O -7.338670 -8.956276 -11.936725 402 4081 4082 + 4081 H -7.205180 -9.461193 -11.112425 403 4080 + 4082 H -8.291268 -8.840677 -12.000288 403 4080 + 4083 O 9.310332 14.156142 -6.279488 402 4084 4085 + 4084 H 10.218649 13.951492 -6.545390 403 4083 + 4085 H 9.258047 14.553265 -5.370592 403 4083 + 4086 O 0.560208 -13.174622 -9.781962 402 4087 4088 + 4087 H 0.439761 -12.748376 -10.646076 403 4086 + 4088 H 0.670280 -14.103731 -9.913873 403 4086 + 4089 O 26.128167 14.199294 -1.068870 402 4090 4091 + 4090 H 26.431992 13.452397 -0.460937 403 4089 + 4091 H 25.201007 14.292566 -1.045597 403 4089 + 4092 O -16.949107 1.727945 -4.563937 402 4093 4094 + 4093 H -16.652995 1.770027 -5.488123 403 4092 + 4094 H -17.803051 2.243334 -4.537865 403 4092 + 4095 O -11.599049 -20.904475 0.385428 402 4096 4097 + 4096 H -11.617180 -19.974350 0.739051 403 4095 + 4097 H -10.733402 -20.802194 -0.016961 403 4095 + 4098 O -25.256117 12.394753 17.084014 402 4099 4100 + 4099 H -24.597187 12.955531 17.523929 403 4098 + 4100 H -25.351341 11.801006 17.816577 403 4098 + 4101 O 21.083077 10.997597 -6.264609 402 4102 4103 + 4102 H 20.914438 11.935561 -6.410001 403 4101 + 4103 H 20.611065 10.573853 -6.944918 403 4101 + 4104 O 24.363484 -19.776402 17.065120 402 4105 4106 + 4105 H 24.744693 -19.074320 16.551577 403 4104 + 4106 H 25.036878 -20.294208 17.436608 403 4104 + 4107 O -10.735684 9.638082 6.150386 402 4108 4109 + 4108 H -10.221167 9.463561 5.360913 403 4107 + 4109 H -11.618988 9.902798 5.921573 403 4107 + 4110 O -14.186781 2.877388 6.286661 402 4111 4112 + 4111 H -14.662769 3.118087 7.092293 403 4110 + 4112 H -14.425510 3.607015 5.695311 403 4110 + 4113 O 23.488790 -12.140879 -16.710373 402 4114 4115 + 4114 H 23.035645 -11.840916 -17.492726 403 4113 + 4115 H 24.198140 -11.533887 -16.669370 403 4113 + 4116 O -9.756394 20.612891 7.487522 402 4117 4118 + 4117 H -10.567829 20.596149 6.941769 403 4116 + 4118 H -9.567427 19.672366 7.650269 403 4116 + 4119 O -10.809623 -15.325182 16.646046 402 4120 4121 + 4120 H -10.540345 -15.380934 15.754906 403 4119 + 4121 H -10.995048 -16.212302 17.003558 403 4119 + 4122 O 23.590175 -14.844140 18.091313 402 4123 4124 + 4123 H 23.082950 -15.642639 17.817614 403 4122 + 4124 H 22.918432 -14.433938 18.680116 403 4122 + 4125 O -9.843301 16.099124 8.917553 402 4126 4127 + 4126 H -10.800912 15.942477 8.746196 403 4125 + 4127 H -9.776206 16.007775 9.870062 403 4125 + 4128 O -15.969686 15.153089 5.232592 402 4129 4130 + 4129 H -15.190596 15.577230 4.796399 403 4128 + 4130 H -16.653218 15.791665 5.086615 403 4128 + 4131 O -14.522038 4.774109 20.092720 402 4132 4133 + 4132 H -13.726552 4.726517 19.600040 403 4131 + 4133 H -14.275341 5.232921 20.890928 403 4131 + 4134 O -19.150467 -13.472817 -2.000864 402 4135 4136 + 4135 H -19.948375 -14.097323 -2.133949 403 4134 + 4136 H -18.565882 -13.718795 -2.719742 403 4134 + 4137 O 26.570568 3.571434 2.677152 402 4138 4139 + 4138 H 26.009960 3.474978 1.867261 403 4137 + 4139 H 25.979473 4.132392 3.254985 403 4137 + 4140 O 2.963742 -20.267378 17.680551 402 4141 4142 + 4141 H 2.939273 -19.702759 18.451804 403 4140 + 4142 H 3.704894 -20.009537 17.129551 403 4140 + 4143 O 12.886914 -16.854820 -15.969948 402 4144 4145 + 4144 H 13.277380 -15.998244 -16.290560 403 4143 + 4145 H 12.084202 -16.946569 -16.485310 403 4143 + 4146 O -13.403098 20.670706 14.180090 402 4147 4148 + 4147 H -12.697115 20.129500 13.825532 403 4146 + 4148 H -13.078241 21.562186 14.353615 403 4146 + 4149 O 1.263724 -2.316623 11.541630 402 4150 4151 + 4150 H 1.604989 -3.147382 11.057854 403 4149 + 4151 H 1.301508 -2.419331 12.514250 403 4149 + 4152 O 16.027424 -2.901060 -7.834089 402 4153 4154 + 4153 H 15.527925 -3.644628 -8.229138 403 4152 + 4154 H 15.964477 -2.241942 -8.584411 403 4152 + 4155 O 20.574908 7.015109 -16.355513 402 4156 4157 + 4156 H 20.799767 7.912603 -16.672696 403 4155 + 4157 H 19.614717 7.020855 -16.464707 403 4155 + 4158 O -9.799678 -16.315433 -2.735469 402 4159 4160 + 4159 H -9.082163 -15.876270 -3.158920 403 4158 + 4160 H -9.675027 -17.234496 -2.912849 403 4158 + 4161 O 19.925358 -1.799248 -13.616500 402 4162 4163 + 4162 H 19.041533 -1.607762 -13.949745 403 4161 + 4163 H 20.105803 -1.002750 -13.099573 403 4161 + 4164 O 26.502531 14.202393 -14.528425 402 4165 4166 + 4165 H 25.566109 14.188457 -14.685868 403 4164 + 4166 H 26.586381 14.616670 -13.692642 403 4164 + 4167 O -3.640972 -15.964509 3.441932 402 4168 4169 + 4168 H -3.916866 -16.633969 4.049731 403 4167 + 4169 H -3.180242 -16.493582 2.755249 403 4167 + 4170 O 20.157853 -15.783144 2.660570 402 4171 4172 + 4171 H 20.419750 -16.681495 2.950489 403 4170 + 4172 H 19.984795 -15.805827 1.709836 403 4170 + 4173 O 3.128568 11.959447 -14.685598 402 4174 4175 + 4174 H 2.607191 12.662191 -15.102263 403 4173 + 4175 H 3.769283 12.428495 -14.079944 403 4173 + 4176 O -24.815536 -15.542873 4.007555 402 4177 4178 + 4177 H -24.218085 -16.000016 3.406953 403 4176 + 4178 H -25.315854 -15.091766 3.403899 403 4176 + 4179 O 19.308952 20.661672 -11.377272 402 4180 4181 + 4180 H 19.335667 21.503703 -10.905560 403 4179 + 4181 H 20.214980 20.602723 -11.631713 403 4179 + 4182 O 13.542822 -5.649499 0.333332 402 4183 4184 + 4183 H 13.963629 -4.763289 0.274336 403 4182 + 4184 H 12.814580 -5.810940 -0.269097 403 4182 + 4185 O 13.690049 -20.143279 -5.943461 402 4186 4187 + 4186 H 13.436356 -20.544177 -6.811045 403 4185 + 4187 H 14.540599 -19.746894 -6.080417 403 4185 + 4188 O -15.552613 1.765055 -16.570745 402 4189 4190 + 4189 H -15.053582 2.345281 -15.988522 403 4188 + 4190 H -15.170829 0.889200 -16.752662 403 4188 + 4191 O 18.304944 6.143260 -6.070829 402 4192 4193 + 4192 H 18.125046 5.326107 -5.570747 403 4191 + 4193 H 18.266448 6.784180 -5.360045 403 4191 + 4194 O 2.506981 -17.274997 10.100766 402 4195 4196 + 4195 H 3.347828 -17.659592 10.064456 403 4194 + 4196 H 2.856471 -16.401034 10.442415 403 4194 + 4197 O -19.165460 9.947070 1.363209 402 4198 4199 + 4198 H -18.730236 10.366229 0.602857 403 4197 + 4199 H -18.849961 10.481480 2.151944 403 4197 + 4200 O -25.980688 17.933161 -0.316559 402 4201 4202 + 4201 H -26.443527 17.228913 -0.781861 403 4200 + 4202 H -25.367896 18.145268 -0.998602 403 4200 + 4203 O -8.979352 -14.825818 -16.044347 402 4204 4205 + 4204 H -8.232685 -15.013438 -15.478412 403 4203 + 4205 H -9.593300 -15.565144 -15.856307 403 4203 + 4206 O -26.878522 10.651550 -5.997590 402 4207 4208 + 4207 H -27.657923 11.080372 -6.414692 403 4206 + 4208 H -26.575102 11.315809 -5.418717 403 4206 + 4209 O 25.946197 20.187421 -17.138659 402 4210 4211 + 4210 H 26.747885 20.729551 -17.283461 403 4209 + 4211 H 25.893413 20.171520 -16.172728 403 4209 + 4212 O -22.758506 -11.646357 10.203824 402 4213 4214 + 4213 H -22.294597 -11.119698 9.558550 403 4212 + 4214 H -22.038786 -12.335635 10.328914 403 4212 + 4215 O 5.051118 -7.506736 -18.096705 402 4216 4217 + 4216 H 5.890399 -6.995469 -18.089124 403 4215 + 4217 H 4.432798 -7.081744 -18.676680 403 4215 + 4218 O -25.361275 -6.967887 -18.797135 402 4219 4220 + 4219 H -24.723765 -6.707007 -18.115496 403 4218 + 4220 H -25.259315 -7.901704 -18.865340 403 4218 + 4221 O -2.799085 -16.680409 -5.658803 402 4222 4223 + 4222 H -3.041668 -16.532466 -4.707237 403 4221 + 4223 H -2.655725 -17.646573 -5.729646 403 4221 + 4224 O 6.961841 -0.650018 14.982518 402 4225 4226 + 4225 H 7.049840 -0.822572 15.899427 403 4224 + 4226 H 7.585417 -1.245556 14.495279 403 4224 + 4227 O -27.328225 -2.775920 4.654966 402 4228 4229 + 4228 H -28.131668 -3.256883 4.960696 403 4227 + 4229 H -26.702154 -2.749977 5.390082 403 4227 + 4230 O -10.545176 15.887401 -11.516094 402 4231 4232 + 4231 H -11.354652 16.437925 -11.631152 403 4230 + 4232 H -10.234139 15.573972 -12.408175 403 4230 + 4233 O 27.293890 -3.784569 13.095470 402 4234 4235 + 4234 H 27.629930 -4.552840 12.571336 403 4233 + 4235 H 27.297508 -4.139921 14.014667 403 4233 + 4236 O 26.677289 -8.930589 -5.080635 402 4237 4238 + 4237 H 27.349144 -8.367067 -5.399678 403 4236 + 4238 H 26.178389 -8.423219 -4.437089 403 4236 + 4239 O 26.303353 -13.709693 -10.199064 402 4240 4241 + 4240 H 26.819339 -13.575870 -11.047002 403 4239 + 4241 H 26.995460 -13.448744 -9.504732 403 4239 + 4242 O -5.782538 -6.137070 -18.577558 402 4243 4244 + 4243 H -5.225175 -5.601455 -18.004594 403 4242 + 4244 H -5.277523 -6.828742 -18.969936 403 4242 + 4245 O -10.751593 15.373515 -8.362078 402 4246 4247 + 4246 H -10.116580 15.133048 -9.031534 403 4245 + 4247 H -11.426882 15.817389 -8.872810 403 4245 + 4248 O 16.641528 -6.647086 14.042481 402 4249 4250 + 4249 H 16.877857 -5.780320 14.352388 403 4248 + 4250 H 15.723201 -6.556522 13.694961 403 4248 + 4251 O -9.692102 -20.433174 12.075319 402 4252 4253 + 4252 H -9.015496 -20.798185 11.574612 403 4251 + 4253 H -10.349277 -21.179838 12.030713 403 4251 + 4254 O -3.342987 5.338933 20.099174 402 4255 4256 + 4255 H -3.147711 5.827567 20.954747 403 4254 + 4256 H -4.124775 5.753362 19.736033 403 4254 + 4257 O 22.616008 -14.603236 0.953729 402 4258 4259 + 4258 H 21.991188 -13.989371 1.394272 403 4257 + 4259 H 22.974372 -14.081510 0.229956 403 4257 + 4260 O -8.097592 12.140479 -19.585886 402 4261 4262 + 4261 H -8.453866 12.623380 -20.326053 403 4260 + 4262 H -8.784224 11.654989 -19.152969 403 4260 + 4263 O -21.232297 5.610953 -16.679404 402 4264 4265 + 4264 H -20.585466 5.060918 -17.156512 403 4263 + 4265 H -21.930038 5.836903 -17.294471 403 4263 + 4266 O -10.747633 18.133699 -14.681278 402 4267 4268 + 4267 H -10.847151 18.670752 -15.499579 403 4266 + 4268 H -9.785896 18.213162 -14.415037 403 4266 + 4269 O 5.277447 -4.914937 -12.832056 402 4270 4271 + 4270 H 4.837973 -4.063025 -13.209955 403 4269 + 4271 H 6.186619 -4.697637 -12.711347 403 4269 + 4272 O 20.041500 5.021710 -2.968457 402 4273 4274 + 4273 H 19.672986 5.469423 -2.234503 403 4272 + 4274 H 20.344328 4.132583 -2.637240 403 4272 + 4275 O 17.907741 2.778212 -8.037993 402 4276 4277 + 4276 H 18.567517 3.366180 -8.410651 403 4275 + 4277 H 17.288995 3.302520 -7.441301 403 4275 + 4278 O 5.562515 -18.543574 -19.590057 402 4279 4280 + 4279 H 6.312662 -18.495893 -20.210476 403 4278 + 4280 H 5.830551 -17.824826 -18.960179 403 4278 + 4281 O 12.736551 -13.896404 -1.831403 402 4282 4283 + 4282 H 12.773597 -12.929037 -1.656141 403 4281 + 4283 H 13.175198 -14.041740 -2.708482 403 4281 + 4284 O -4.469179 -3.097942 -13.481704 402 4285 4286 + 4285 H -3.873920 -2.479353 -13.901987 403 4284 + 4286 H -5.276658 -2.695674 -13.122340 403 4284 + 4287 O -21.439043 8.219030 17.863426 402 4288 4289 + 4288 H -21.056703 8.853759 17.338517 403 4287 + 4289 H -21.129569 7.386574 17.512818 403 4287 + 4290 O -20.342022 -7.199464 17.782819 402 4291 4292 + 4291 H -19.811208 -6.577246 18.288787 403 4290 + 4292 H -19.701668 -7.908647 17.571092 403 4290 + 4293 O -14.263922 5.278640 -18.510906 402 4294 4295 + 4294 H -13.564113 4.937165 -17.913388 403 4293 + 4295 H -14.930181 4.580837 -18.615930 403 4293 + 4296 O 16.913731 -14.141037 14.480884 402 4297 4298 + 4297 H 16.066655 -13.798463 14.461234 403 4296 + 4298 H 17.548578 -13.399940 14.431310 403 4296 + 4299 O -25.968088 14.659464 5.007859 402 4300 4301 + 4300 H -25.454004 13.822928 4.891375 403 4299 + 4301 H -26.104124 14.757551 5.974942 403 4299 + 4302 O -18.135969 17.732537 5.080161 402 4303 4304 + 4303 H -18.773193 18.355342 5.390012 403 4302 + 4304 H -18.159466 17.860761 4.093910 403 4302 + 4305 O -27.275820 -16.400609 -7.043757 402 4306 4307 + 4306 H -26.590275 -16.756481 -6.431378 403 4305 + 4307 H -27.617212 -15.617979 -6.640114 403 4305 + 4308 O 24.748058 17.280534 18.064239 402 4309 4310 + 4309 H 25.308718 17.915370 18.504903 403 4308 + 4310 H 24.056361 17.050512 18.710421 403 4308 + 4311 O -24.811053 1.584408 5.834113 402 4312 4313 + 4312 H -25.507909 1.858017 6.420755 403 4311 + 4313 H -25.030959 2.043401 4.912778 403 4311 + 4314 O -17.538048 -16.019040 8.437894 402 4315 4316 + 4315 H -16.656025 -15.917276 8.786670 403 4314 + 4316 H -18.001949 -16.630915 9.146335 403 4314 + 4317 O 24.760362 7.007344 2.270076 402 4318 4319 + 4318 H 25.402754 6.314627 2.489308 403 4317 + 4319 H 23.915754 6.586671 2.268737 403 4317 + 4320 O 25.788659 -3.059441 10.761911 402 4321 4322 + 4321 H 26.310282 -3.490606 11.381049 403 4320 + 4322 H 26.152501 -2.184136 10.493232 403 4320 + 4323 O 0.555207 13.578019 -13.771204 402 4324 4325 + 4324 H 0.341766 12.780750 -14.192088 403 4323 + 4325 H 0.413626 13.443525 -12.823611 403 4323 + 4326 O 20.410457 17.119094 12.037026 402 4327 4328 + 4327 H 20.229518 17.254716 12.960534 403 4326 + 4328 H 19.888401 16.300517 11.792550 403 4326 + 4329 O -23.997550 7.377972 16.665323 402 4330 4331 + 4330 H -23.725736 7.038438 15.778438 403 4329 + 4331 H -23.233133 7.945952 17.026136 403 4329 + 4332 O 10.209255 5.785175 12.171401 402 4333 4334 + 4333 H 10.101397 6.356166 11.459081 403 4332 + 4334 H 9.657068 5.061974 12.024038 403 4332 + 4335 O 18.434676 -10.560721 -17.755033 402 4336 4337 + 4336 H 18.443899 -11.522200 -17.622101 403 4335 + 4337 H 18.319805 -10.178413 -16.882655 403 4335 + 4338 O -27.095192 -12.657493 -12.643385 402 4339 4340 + 4339 H -26.627310 -12.318558 -13.484881 403 4338 + 4340 H -26.470420 -12.949131 -11.963689 403 4338 + 4341 O -16.616222 15.445597 -12.118963 402 4342 4343 + 4342 H -16.900898 14.503610 -11.855586 403 4341 + 4343 H -15.694269 15.632029 -11.755889 403 4341 + 4344 O 21.704052 -7.110846 5.569340 402 4345 4346 + 4345 H 21.462097 -8.042671 5.894386 403 4344 + 4346 H 20.943089 -6.635884 5.906995 403 4344 + 4347 O 18.206432 16.827370 1.010928 402 4348 4349 + 4348 H 17.640465 17.264033 0.353478 403 4347 + 4349 H 17.852918 17.062780 1.898646 403 4347 + 4350 O -11.473367 18.497190 -2.566431 402 4351 4352 + 4351 H -11.979906 19.196582 -2.198797 403 4350 + 4352 H -11.280546 18.932999 -3.450291 403 4350 + 4353 O 17.797648 10.068787 -6.366632 402 4354 4355 + 4354 H 17.894506 9.407090 -5.699458 403 4353 + 4355 H 18.545928 9.973231 -6.994936 403 4353 + 4356 O -18.401148 -11.350055 -12.827243 402 4357 4358 + 4357 H -18.476782 -10.412318 -13.195678 403 4356 + 4358 H -17.491834 -11.585994 -12.934422 403 4356 + 4359 O -16.495719 -5.941792 10.422239 402 4360 4361 + 4360 H -16.334766 -5.213442 11.122849 403 4359 + 4361 H -16.639135 -6.780551 10.923477 403 4359 + 4362 O -11.586396 18.803652 -7.549338 402 4363 4364 + 4363 H -12.019098 18.189302 -8.166804 403 4362 + 4364 H -11.712347 18.317066 -6.668883 403 4362 + 4365 O 11.058497 -1.697211 6.108850 402 4366 4367 + 4366 H 11.596453 -0.983751 6.451941 403 4365 + 4367 H 10.144328 -1.357434 6.135852 403 4365 + 4368 O -6.655801 13.749288 -17.439254 402 4369 4370 + 4369 H -7.132448 13.358752 -18.156046 403 4368 + 4370 H -7.118927 14.596314 -17.196637 403 4368 + 4371 O 1.472049 -16.138831 -18.127087 402 4372 4373 + 4372 H 0.854396 -15.448228 -18.418147 403 4371 + 4373 H 2.130556 -15.578106 -17.697816 403 4371 + 4374 O 20.585602 0.045789 -20.805188 402 4375 4376 + 4375 H 19.811710 0.249922 -20.316920 403 4374 + 4376 H 20.451948 -0.908979 -20.865716 403 4374 + 4377 O -17.322452 12.895993 -11.204513 402 4378 4379 + 4378 H -17.802771 12.549260 -12.003007 403 4377 + 4379 H -17.950866 13.176295 -10.574188 403 4377 + 4380 O -5.523481 17.380120 9.246553 402 4381 4382 + 4381 H -6.455503 17.665024 9.326329 403 4380 + 4382 H -5.168113 17.988295 8.544540 403 4380 + 4383 O -20.625677 5.350199 17.142096 402 4384 4385 + 4384 H -20.365541 5.269750 16.185658 403 4383 + 4385 H -21.560214 5.201087 17.226176 403 4383 + 4386 O 14.783181 -14.244465 0.085624 402 4387 4388 + 4387 H 14.103412 -14.020780 -0.585079 403 4386 + 4388 H 15.175676 -13.378076 0.287496 403 4386 + 4389 O -6.126500 15.521051 20.750377 402 4390 4391 + 4390 H -5.864785 16.375379 20.437098 403 4389 + 4391 H -5.831488 14.924080 20.076176 403 4389 + 4392 O 23.807408 -1.524862 20.387679 402 4393 4394 + 4393 H 23.526614 -0.919002 21.138248 403 4392 + 4394 H 24.692883 -1.828224 20.645004 403 4392 + 4395 O -19.809983 -10.410676 13.714221 402 4396 4397 + 4396 H -20.768119 -10.598102 13.488906 403 4395 + 4397 H -19.553271 -11.125518 14.242975 403 4395 + 4398 O 10.977545 9.011145 -2.389433 402 4399 4400 + 4399 H 10.555694 9.915559 -2.389522 403 4398 + 4400 H 11.154202 8.870964 -1.470695 403 4398 + 4401 O -1.783860 4.881032 16.604931 402 4402 4403 + 4402 H -1.311789 5.388703 17.223932 403 4401 + 4403 H -2.422445 4.514982 17.225489 403 4401 + 4404 O 7.835617 -8.106110 -15.760424 402 4405 4406 + 4405 H 7.624633 -7.756681 -14.894547 403 4404 + 4406 H 8.420342 -7.335138 -16.124751 403 4404 + 4407 O -23.662148 -13.962817 6.282978 402 4408 4409 + 4408 H -23.067991 -14.398941 6.936570 403 4407 + 4409 H -23.877149 -14.577723 5.532763 403 4407 + 4410 O -23.624539 2.173832 -0.854956 402 4411 4412 + 4411 H -23.179146 2.179020 0.040340 403 4410 + 4412 H -23.749597 1.237465 -1.001396 403 4410 + 4413 O -21.224847 4.257385 -6.009865 402 4414 4415 + 4414 H -20.741474 3.800756 -5.299605 403 4413 + 4415 H -22.182298 4.137922 -5.723698 403 4413 + 4416 O -7.017487 16.063624 -12.051636 402 4417 4418 + 4417 H -6.269158 16.416276 -11.536793 403 4416 + 4418 H -7.636713 15.594733 -11.454123 403 4416 + 4419 O -5.651528 10.093505 -13.321462 402 4420 4421 + 4420 H -6.401351 10.663800 -13.086078 403 4419 + 4421 H -5.597617 10.115851 -14.301208 403 4419 + 4422 O 21.418715 -14.140702 -12.149975 402 4423 4424 + 4423 H 21.861018 -14.674641 -11.447553 403 4422 + 4424 H 21.182805 -13.281849 -11.830093 403 4422 + 4425 O 11.675702 -2.428019 -16.058290 402 4426 4427 + 4426 H 12.296485 -3.131417 -15.821102 403 4425 + 4427 H 10.819347 -2.825354 -16.198440 403 4425 + 4428 O 22.979820 -2.598953 7.858168 402 4429 4430 + 4429 H 22.305897 -3.288078 7.958439 403 4428 + 4430 H 22.577225 -1.844154 8.317572 403 4428 + 4431 O -12.448543 -5.982245 -10.570856 402 4432 4433 + 4432 H -12.345287 -6.440367 -11.438582 403 4431 + 4433 H -12.479780 -5.112730 -10.871625 403 4431 + 4434 O -21.326982 14.741209 3.984994 402 4435 4436 + 4435 H -22.133596 15.218464 4.095957 403 4434 + 4436 H -21.095649 14.791647 3.001164 403 4434 + 4437 O -18.292976 8.601702 17.515296 402 4438 4439 + 4438 H -17.819784 7.959109 16.915944 403 4437 + 4439 H -18.716579 9.254092 16.954312 403 4437 + 4440 O 20.829524 -9.495435 17.330944 402 4441 4442 + 4441 H 20.166412 -8.937403 16.904816 403 4440 + 4442 H 20.227087 -10.108486 17.846508 403 4440 + 4443 O 20.700328 -6.588173 14.108279 402 4444 4445 + 4444 H 21.318200 -6.371434 13.409947 403 4443 + 4445 H 20.919049 -5.966297 14.775431 403 4443 + 4446 O 20.232319 2.519356 -1.744863 402 4447 4448 + 4447 H 19.792632 2.343537 -0.866566 403 4446 + 4448 H 20.751642 1.718603 -1.892919 403 4446 + 4449 O 15.047686 14.467227 0.247890 402 4450 4451 + 4450 H 15.482736 13.695414 -0.222271 403 4449 + 4451 H 15.218594 15.203623 -0.400616 403 4449 + 4452 O 24.814901 -4.572712 18.521288 402 4453 4454 + 4453 H 24.436069 -3.989712 17.861088 403 4452 + 4454 H 24.560432 -4.263207 19.423396 403 4452 + 4455 O 3.169892 -14.115589 5.242292 402 4456 4457 + 4456 H 2.664005 -13.989979 6.094893 403 4455 + 4457 H 4.025199 -14.428367 5.639157 403 4455 + 4458 O -17.864265 -2.850216 -5.852738 402 4459 4460 + 4459 H -17.430066 -2.321482 -5.131734 403 4458 + 4460 H -17.446095 -3.672125 -5.727214 403 4458 + 4461 O -13.642312 16.367207 3.840240 402 4462 4463 + 4462 H -13.546920 17.318166 3.892058 403 4461 + 4463 H -12.985388 16.154870 4.544614 403 4461 + 4464 O 15.575472 3.168399 -6.551464 402 4465 4466 + 4465 H 15.114514 3.591709 -7.323565 403 4464 + 4466 H 15.203187 3.608807 -5.831817 403 4464 + 4467 O -21.816911 -17.666243 7.967285 402 4468 4469 + 4468 H -21.649191 -17.232658 7.144499 403 4467 + 4469 H -22.407552 -17.039323 8.334081 403 4467 + 4470 O -19.125021 -12.172620 15.597940 402 4471 4472 + 4471 H -18.215275 -12.242849 15.770287 403 4470 + 4472 H -19.633754 -12.872939 15.973922 403 4470 + 4473 O 17.584300 -5.074564 -0.037211 402 4474 4475 + 4474 H 18.183319 -5.137038 0.675699 403 4473 + 4475 H 18.235909 -5.047683 -0.784982 403 4473 + 4476 O 26.562235 4.146721 -10.779327 402 4477 4478 + 4477 H 27.258204 4.596271 -10.364313 403 4476 + 4478 H 26.892796 3.237656 -11.037254 403 4476 + 4479 O -23.034850 1.331983 -7.473112 402 4480 4481 + 4480 H -22.263084 1.153047 -6.915575 403 4479 + 4481 H -23.725786 1.086847 -6.826224 403 4479 + 4482 O 24.491038 14.753421 2.384575 402 4483 4484 + 4483 H 24.275342 13.963741 2.927789 403 4482 + 4484 H 25.462558 14.841355 2.559853 403 4482 + 4485 O 25.756605 20.905461 -14.371089 402 4486 4487 + 4486 H 25.459034 20.605712 -13.483891 403 4485 + 4487 H 25.637109 21.868510 -14.335232 403 4485 + 4488 O 18.144532 -1.757335 -11.270502 402 4489 4490 + 4489 H 18.514080 -2.646244 -11.055555 403 4488 + 4490 H 18.939318 -1.202686 -11.251734 403 4488 + 4491 O -8.201074 -18.018606 -17.312094 402 4492 4493 + 4492 H -8.700168 -17.307968 -17.835946 403 4491 + 4493 H -7.577873 -18.381345 -17.962687 403 4491 + 4494 O -9.369914 -19.217851 -15.403305 402 4495 4496 + 4495 H -8.952768 -18.975805 -16.243189 403 4494 + 4496 H -8.911643 -18.742350 -14.709664 403 4494 + 4497 O 20.100577 4.488027 -15.212556 402 4498 4499 + 4498 H 20.248911 5.438169 -15.424742 403 4497 + 4499 H 20.660237 3.933680 -15.689536 403 4497 + 4500 O -19.712024 -15.323556 12.551955 402 4501 4502 + 4501 H -19.317175 -16.207750 12.463402 403 4500 + 4502 H -19.212616 -14.787825 13.210358 403 4500 + 4503 O 3.258787 -7.943131 12.290678 402 4504 4505 + 4504 H 2.342628 -8.287555 12.320149 403 4503 + 4505 H 3.267355 -6.993463 12.332634 403 4503 + 4506 O -18.302710 1.278985 -16.334436 402 4507 4508 + 4507 H -17.378406 1.373256 -16.132103 403 4506 + 4508 H -18.777760 1.517880 -15.493665 403 4506 + 4509 O 16.870546 4.656852 -17.868704 402 4510 4511 + 4510 H 15.857496 4.704340 -17.988259 403 4509 + 4511 H 17.247038 4.338791 -18.723974 403 4509 + 4512 O -15.333473 15.071500 7.805725 402 4513 4514 + 4513 H -15.704647 14.257623 8.137122 403 4512 + 4514 H -15.627172 15.251727 6.915271 403 4512 + 4515 O 9.979483 20.165851 2.918770 402 4516 4517 + 4516 H 9.638769 20.645174 2.150266 403 4515 + 4517 H 9.859690 19.210620 2.805973 403 4515 + 4518 O 23.413497 4.631399 15.271695 402 4519 4520 + 4519 H 23.659592 4.570914 14.363590 403 4518 + 4520 H 23.076746 5.481003 15.471203 403 4518 + 4521 O 23.514270 -0.269090 17.919270 402 4522 4523 + 4522 H 23.883706 -0.646818 18.744448 403 4521 + 4523 H 22.647737 0.129763 18.103196 403 4521 + 4524 O -24.064290 4.819702 1.332253 402 4525 4526 + 4525 H -24.383325 4.040819 1.008702 403 4524 + 4526 H -23.189236 4.997095 0.898826 403 4524 + 4527 O -25.779315 -8.150537 18.610217 402 4528 4529 + 4528 H -24.782772 -7.888401 18.544405 403 4527 + 4529 H -26.257671 -7.381934 18.370006 403 4527 + 4530 O 23.115913 16.716123 3.668102 402 4531 4532 + 4531 H 23.749362 16.385349 2.997452 403 4530 + 4532 H 23.088241 17.666029 3.599261 403 4530 + 4533 O -20.088868 -15.143633 -10.159937 402 4534 4535 + 4534 H -19.953025 -14.270168 -10.582681 403 4533 + 4535 H -19.990998 -15.687042 -10.954781 403 4533 + 4536 O 7.102126 -1.136927 20.971306 402 4537 4538 + 4537 H 6.576190 -1.521838 20.280208 403 4536 + 4538 H 7.955207 -1.040834 20.509983 403 4536 + 4539 O -2.534299 9.690544 11.933304 402 4540 4541 + 4540 H -2.860248 8.888179 11.453477 403 4539 + 4541 H -1.828854 10.072496 11.393589 403 4539 + 4542 O 12.023524 -9.150206 -14.165841 402 4543 4544 + 4543 H 11.362618 -9.759930 -14.520833 403 4542 + 4544 H 12.740525 -9.263946 -14.788240 403 4542 + 4545 O 15.791803 18.545995 0.850378 402 4546 4547 + 4546 H 16.437977 18.981342 1.416680 403 4545 + 4547 H 14.975349 18.624193 1.311898 403 4545 + 4548 O -23.993331 13.937802 7.429388 402 4549 4550 + 4549 H -23.946766 13.591295 6.487146 403 4548 + 4550 H -23.318125 14.639075 7.439315 403 4548 + 4551 O 23.938328 -2.346007 3.554880 402 4552 4553 + 4552 H 24.343685 -3.093714 4.072487 403 4551 + 4553 H 24.649326 -2.174810 2.889988 403 4551 + 4554 O -1.744771 13.957566 2.002292 402 4555 4556 + 4555 H -0.940707 14.398422 2.247093 403 4554 + 4556 H -2.025476 14.420450 1.204293 403 4554 + 4557 O -25.534328 -15.482539 7.809635 402 4558 4559 + 4558 H -25.054678 -15.173162 7.005447 403 4557 + 4559 H -26.465036 -15.629268 7.587481 403 4557 + 4560 O 24.624742 -18.307755 -10.821110 402 4561 4562 + 4561 H 23.724217 -18.723401 -10.975653 403 4560 + 4562 H 24.780187 -17.602754 -11.546790 403 4560 + 4563 O -21.325143 19.316329 -1.400937 402 4564 4565 + 4564 H -21.154588 18.656956 -0.705637 403 4563 + 4565 H -20.679486 19.156150 -2.095481 403 4563 + 4566 O 0.559384 -5.922570 14.213390 402 4567 4568 + 4567 H 1.239405 -5.963730 14.899585 403 4566 + 4568 H 0.030681 -5.131536 14.297850 403 4566 + 4569 O 7.056613 12.758986 15.777863 402 4570 4571 + 4570 H 6.345829 12.596606 16.456405 403 4569 + 4571 H 6.917568 12.084839 15.095389 403 4569 + 4572 O 7.882824 3.878180 -19.492657 402 4573 4574 + 4573 H 7.490185 4.569137 -19.983338 403 4572 + 4574 H 7.617907 3.037912 -19.945297 403 4572 + 4575 O -4.242915 -9.821169 16.240099 402 4576 4577 + 4576 H -5.114830 -10.078772 16.528494 403 4575 + 4577 H -4.353835 -8.852979 15.979121 403 4575 + 4578 O 15.302976 18.208896 -11.851032 402 4579 4580 + 4579 H 14.901111 18.506138 -12.642478 403 4578 + 4580 H 14.917266 17.320837 -11.712610 403 4578 + 4581 O -18.266869 -16.450266 -8.528802 402 4582 4583 + 4582 H -19.072723 -16.071961 -9.086324 403 4581 + 4583 H -18.243043 -17.366820 -8.807270 403 4581 + 4584 O 16.535819 -20.059315 20.261479 402 4585 4586 + 4585 H 16.531825 -20.982895 19.988148 403 4584 + 4586 H 16.217098 -19.563433 19.483491 403 4584 + 4587 O -10.711611 3.116140 -11.835025 402 4588 4589 + 4588 H -10.699224 2.230856 -12.204415 403 4587 + 4589 H -10.469479 3.689824 -12.532473 403 4587 + 4590 O -3.907796 14.129489 -14.135830 402 4591 4592 + 4591 H -3.774958 15.065764 -14.110303 403 4590 + 4592 H -4.871885 13.969469 -14.280187 403 4590 + 4593 O -0.848559 15.883551 -14.784892 402 4594 4595 + 4594 H -0.414200 14.990499 -14.630689 403 4593 + 4595 H -1.164070 15.745918 -15.703167 403 4593 + 4596 O 26.710694 15.162885 -7.381020 402 4597 4598 + 4597 H 26.708875 16.144027 -7.444500 403 4596 + 4598 H 27.516272 14.997257 -7.900997 403 4596 + 4599 O -20.320110 2.222669 -14.437513 402 4600 4601 + 4600 H -20.674693 1.937159 -13.587288 403 4599 + 4601 H -21.090888 2.252982 -14.954492 403 4599 + 4602 O -18.681714 17.640935 -1.514728 402 4603 4604 + 4603 H -19.273979 17.179134 -2.084688 403 4602 + 4604 H -18.333083 16.926527 -0.959606 403 4602 + 4605 O 26.297214 0.194896 -8.814341 402 4606 4607 + 4606 H 26.092612 0.771392 -8.062520 403 4605 + 4607 H 25.469129 -0.223458 -9.080468 403 4605 + 4608 O 5.191134 -6.332696 -10.274288 402 4609 4610 + 4609 H 6.147598 -6.194127 -10.166488 403 4608 + 4610 H 4.968608 -5.815003 -11.012193 403 4608 + 4611 O 20.219068 -19.874563 -6.779564 402 4612 4613 + 4612 H 19.984433 -20.709740 -7.181101 403 4611 + 4613 H 20.478152 -20.150413 -5.862690 403 4611 + 4614 O 15.925069 -5.315100 -4.962971 402 4615 4616 + 4615 H 16.483651 -4.538813 -4.855095 403 4614 + 4616 H 16.031011 -5.844220 -4.094051 403 4614 + 4617 O -24.041642 -19.508457 3.561309 402 4618 4619 + 4618 H -23.889244 -19.214184 4.445568 403 4617 + 4619 H -23.734917 -20.488280 3.584072 403 4617 + 4620 O -7.947126 8.409362 14.208637 402 4621 4622 + 4621 H -8.729737 8.295090 13.605991 403 4620 + 4622 H -7.220157 7.896970 13.768244 403 4620 + 4623 O -20.888915 18.615896 3.147997 402 4624 4625 + 4624 H -20.353651 18.339741 3.899224 403 4623 + 4625 H -20.608848 18.126465 2.400982 403 4623 + 4626 O 26.799597 -16.513942 12.340813 402 4627 4628 + 4627 H 27.311676 -15.749176 12.455669 403 4626 + 4628 H 26.641412 -16.884054 13.252799 403 4626 + 4629 O 22.610810 -16.125525 -11.025534 402 4630 4631 + 4630 H 23.428805 -16.214604 -10.496780 403 4629 + 4631 H 22.231404 -17.004775 -11.137826 403 4629 + 4632 O 23.631086 9.762764 -6.151528 402 4633 4634 + 4633 H 22.831437 10.283165 -6.251895 403 4632 + 4634 H 23.313903 8.866850 -6.410178 403 4632 + 4635 O 10.407629 -5.135788 9.642425 402 4636 4637 + 4636 H 9.500671 -5.522467 9.593528 403 4635 + 4637 H 10.722620 -5.079856 8.742604 403 4635 + 4638 O 4.000382 -9.483456 -16.043131 402 4639 4640 + 4639 H 4.388443 -8.972484 -16.767773 403 4638 + 4640 H 3.270597 -9.958423 -16.410357 403 4638 + 4641 O -25.904986 -15.880364 18.652683 402 4642 4643 + 4642 H -26.778482 -15.886913 19.026359 403 4641 + 4643 H -25.526797 -16.780938 18.932335 403 4641 + 4644 O 15.308933 1.325497 -13.930838 402 4645 4646 + 4645 H 15.049598 0.974163 -14.793125 403 4644 + 4646 H 14.735466 2.123881 -13.829588 403 4644 + 4647 O -6.379415 2.888159 -18.944523 402 4648 4649 + 4648 H -6.573457 2.028181 -19.291846 403 4647 + 4649 H -5.489918 2.985716 -19.266815 403 4647 + 4650 O -1.982477 0.360990 19.729630 402 4651 4652 + 4651 H -2.393479 -0.007753 20.516214 403 4650 + 4652 H -2.616886 0.223553 19.013623 403 4650 + 4653 O 1.410741 17.503605 17.946189 402 4654 4655 + 4654 H 1.299933 17.358511 17.001928 403 4653 + 4655 H 1.382712 16.600387 18.282286 403 4653 + 4656 O -17.081613 19.032309 -4.304375 402 4657 4658 + 4657 H -18.004189 18.728506 -4.171643 403 4656 + 4658 H -16.569290 18.434220 -3.790534 403 4656 + 4659 O 26.981274 -11.552908 -3.820441 402 4660 4661 + 4660 H 26.121174 -11.624996 -4.253473 403 4659 + 4661 H 27.276376 -10.703146 -4.209015 403 4659 + 4662 O 20.095481 18.572235 3.036961 402 4663 4664 + 4663 H 20.026299 17.806007 3.594224 403 4662 + 4664 H 20.832186 19.036343 3.467658 403 4662 + 4665 O -19.905861 6.946943 4.083849 402 4666 4667 + 4666 H -19.307403 7.160688 3.357801 403 4665 + 4667 H -20.728729 7.427643 3.991449 403 4665 + 4668 O 22.217595 -4.822160 -10.650121 402 4669 4670 + 4669 H 22.159340 -5.054178 -11.530210 403 4668 + 4670 H 21.255204 -4.714847 -10.351112 403 4668 + 4671 O 12.390352 -19.538948 -0.083493 402 4672 4673 + 4672 H 13.062326 -18.900361 -0.469572 403 4671 + 4673 H 11.739170 -19.679826 -0.768861 403 4671 + 4674 O -11.756735 -11.595474 -18.753407 402 4675 4676 + 4675 H -10.845705 -11.914606 -18.999006 403 4674 + 4676 H -11.631200 -10.619419 -18.528946 403 4674 + 4677 O 16.531650 8.079043 16.659190 402 4678 4679 + 4678 H 16.426030 8.463579 15.788072 403 4677 + 4679 H 17.442132 8.278108 16.859520 403 4677 + 4680 O 10.052731 8.649788 -10.126307 402 4681 4682 + 4681 H 10.131192 7.907466 -9.580859 403 4680 + 4682 H 10.118299 9.470033 -9.652222 403 4680 + 4683 O 10.138877 6.520965 -16.282122 402 4684 4685 + 4684 H 9.429867 6.198945 -15.746097 403 4683 + 4685 H 9.762597 7.172991 -16.879414 403 4683 + 4686 O -5.128627 7.237138 -16.384778 402 4687 4688 + 4687 H -4.943315 6.311211 -16.467826 403 4686 + 4688 H -4.299328 7.630954 -16.159960 403 4686 + 4689 O 18.467732 -4.333427 -7.973507 402 4690 4691 + 4690 H 17.685481 -3.749427 -7.814406 403 4689 + 4691 H 18.051764 -5.199527 -7.872728 403 4689 + 4692 O -22.790877 -7.110126 -2.658913 402 4693 4694 + 4693 H -22.592444 -7.612682 -1.822969 403 4692 + 4694 H -23.671839 -6.831554 -2.552705 403 4692 + 4695 O -5.452870 -18.001674 4.454273 402 4696 4697 + 4696 H -5.227357 -18.684872 5.061214 403 4695 + 4697 H -6.200455 -17.594596 4.818204 403 4695 + 4698 O 6.056152 -17.434479 -7.972778 402 4699 4700 + 4699 H 6.787809 -18.060671 -8.028928 403 4698 + 4700 H 5.440331 -17.702859 -7.267591 403 4698 + 4701 O 1.714168 -18.930287 -17.718130 402 4702 4703 + 4702 H 1.740272 -18.003727 -18.035560 403 4701 + 4703 H 0.785802 -19.119877 -17.580120 403 4701 + 4704 O 12.454449 16.569541 -9.572034 402 4705 4706 + 4705 H 13.143421 15.995002 -9.358789 403 4704 + 4706 H 11.970081 16.409711 -8.733167 403 4704 + 4707 O 21.377566 -4.531623 -13.959167 402 4708 4709 + 4708 H 21.220313 -4.586863 -14.883806 403 4707 + 4709 H 20.718007 -3.864167 -13.706228 403 4707 + 4710 O 27.229945 -1.071212 -13.106863 402 4711 4712 + 4711 H 26.536738 -0.401088 -12.953451 403 4710 + 4712 H 27.406489 -1.591477 -12.306455 403 4710 + 4713 O 0.993205 -20.183906 13.537173 402 4714 4715 + 4714 H 1.864290 -20.100713 13.823720 403 4713 + 4715 H 0.417346 -20.489716 14.247240 403 4713 + 4716 O 22.306745 2.581458 8.736617 402 4717 4718 + 4717 H 22.972169 3.057047 8.241655 403 4716 + 4718 H 21.515448 2.587605 8.237638 403 4716 + 4719 O -24.994740 17.845616 8.243126 402 4720 4721 + 4720 H -25.935974 17.671320 8.306538 403 4719 + 4721 H -24.615426 17.427508 9.019818 403 4719 + 4722 O 3.628195 -4.198159 -16.200147 402 4723 4724 + 4723 H 4.404223 -4.757640 -16.114355 403 4722 + 4724 H 2.941004 -4.862278 -16.461468 403 4722 + 4725 O 26.808990 -14.261974 -5.551088 402 4726 4727 + 4726 H 26.801404 -13.726938 -6.334245 403 4725 + 4727 H 25.872464 -14.345791 -5.184066 403 4725 + 4728 O 13.355891 -16.600141 -3.794039 402 4729 4730 + 4729 H 13.295908 -17.531097 -3.472837 403 4728 + 4730 H 14.114590 -16.215977 -3.304966 403 4728 + 4731 O -5.285172 -14.650134 6.726219 402 4732 4733 + 4732 H -5.321392 -15.573092 6.451324 403 4731 + 4733 H -5.705533 -14.040342 6.049451 403 4731 + 4734 O -15.245133 11.577568 10.198692 402 4735 4736 + 4735 H -14.684069 10.842805 9.868029 403 4734 + 4736 H -15.899308 11.783343 9.507232 403 4734 + 4737 O 17.485666 -16.919340 -6.354127 402 4738 4739 + 4738 H 17.235852 -17.135664 -7.261939 403 4737 + 4739 H 18.432637 -16.981881 -6.360484 403 4737 + 4740 O -9.901382 -6.924152 -10.070687 402 4741 4742 + 4741 H -10.735776 -6.481799 -9.885298 403 4740 + 4742 H -10.186933 -7.424453 -10.836686 403 4740 + 4743 O -24.779066 9.890774 -10.589824 402 4744 4745 + 4744 H -24.555747 10.752218 -10.986744 403 4743 + 4745 H -24.892417 10.088688 -9.640328 403 4743 + 4746 O -22.615173 9.224641 6.611089 402 4747 4748 + 4747 H -22.778201 8.680839 5.764537 403 4746 + 4748 H -23.446696 9.423303 6.964274 403 4746 + 4749 O 9.268447 -16.931793 -5.987149 402 4750 4751 + 4750 H 8.956403 -16.451784 -6.788388 403 4749 + 4751 H 9.877183 -16.351625 -5.503938 403 4749 + 4752 O -14.656535 1.482956 18.890158 402 4753 4754 + 4753 H -15.369331 1.942366 19.276786 403 4752 + 4754 H -14.153965 0.952532 19.494908 403 4752 + 4755 O 5.277331 10.616617 -11.480664 402 4756 4757 + 4756 H 5.005306 11.447583 -11.898782 403 4755 + 4757 H 5.358629 10.918462 -10.514309 403 4755 + 4758 O 25.665486 11.699398 -16.256540 402 4759 4760 + 4759 H 25.839240 12.448046 -15.719245 403 4758 + 4760 H 25.814575 10.942656 -15.634104 403 4758 + 4761 O 21.920761 20.073624 -12.126972 402 4762 4763 + 4762 H 22.552772 19.967397 -11.382127 403 4761 + 4763 H 21.479644 19.202351 -12.146674 403 4761 + 4764 O 10.003073 19.989386 -7.403776 402 4765 4766 + 4765 H 9.439166 20.478736 -6.817011 403 4764 + 4766 H 9.975278 19.064238 -7.087034 403 4764 + 4767 O 24.639512 10.361086 12.201260 402 4768 4769 + 4768 H 24.706246 9.532944 12.698966 403 4767 + 4769 H 25.008910 11.010832 12.873283 403 4767 + 4770 O -4.551351 -13.614062 11.550986 402 4771 4772 + 4771 H -3.695594 -13.200426 11.181108 403 4770 + 4772 H -4.841622 -13.040560 12.238016 403 4770 + 4773 O 13.925499 -14.277948 -16.852509 402 4774 4775 + 4774 H 13.468499 -13.949023 -16.059490 403 4773 + 4775 H 13.404967 -13.901558 -17.624653 403 4773 + 4776 O -8.822453 18.672284 -1.497284 402 4777 4778 + 4777 H -9.773739 18.628726 -1.762866 403 4776 + 4778 H -8.737384 19.554941 -1.117958 403 4776 + 4779 O -22.502543 14.174443 -14.775760 402 4780 4781 + 4780 H -23.095969 13.602099 -14.242424 403 4779 + 4781 H -22.857075 15.080918 -14.689705 403 4779 + 4782 O 14.064111 -5.559010 13.387762 402 4783 4784 + 4783 H 14.064485 -4.565565 13.355502 403 4782 + 4784 H 13.283489 -5.675258 12.845674 403 4782 + 4785 O 1.894767 -5.320136 -19.924307 402 4786 4787 + 4786 H 1.751326 -5.338831 -18.971201 403 4785 + 4787 H 2.815685 -5.078504 -20.067932 403 4785 + 4788 O 25.294324 -10.049317 -2.168254 402 4789 4790 + 4789 H 24.998964 -9.181655 -2.438448 403 4788 + 4790 H 25.460965 -9.966915 -1.197557 403 4788 + 4791 O 6.479700 -19.891353 1.298943 402 4792 4793 + 4792 H 5.533528 -20.103717 1.361966 403 4791 + 4793 H 6.573201 -19.075339 0.809570 403 4791 + 4794 O -27.363431 -16.882485 4.699786 402 4795 4796 + 4795 H -26.488335 -16.423824 4.667383 403 4794 + 4796 H -27.778495 -16.519493 5.529189 403 4794 + 4797 O 21.647371 -10.967083 -0.688726 402 4798 4799 + 4798 H 21.307654 -11.566578 -0.059145 403 4797 + 4799 H 20.903506 -10.948374 -1.343290 403 4797 + 4800 O -22.639740 18.869062 12.772784 402 4801 4802 + 4801 H -23.598249 18.977251 12.816087 403 4800 + 4802 H -22.528147 18.565590 11.856412 403 4800 + 4803 O -19.354849 19.459324 -20.763860 402 4804 4805 + 4804 H -19.638921 18.619981 -20.405119 403 4803 + 4805 H -19.999366 20.121418 -20.384538 403 4803 + 4806 O -27.292577 17.947849 -7.899480 402 4807 4808 + 4807 H -26.865640 18.369463 -8.665053 403 4806 + 4808 H -26.976583 18.519563 -7.163255 403 4806 + 4809 O -20.817821 -2.868450 14.802525 402 4810 4811 + 4810 H -21.140828 -3.572172 14.242551 403 4809 + 4811 H -21.382527 -2.899729 15.647552 403 4809 + 4812 O -26.483700 3.477220 -8.027358 402 4813 4814 + 4813 H -27.118971 4.203207 -8.001463 403 4812 + 4814 H -25.572543 3.766211 -8.004075 403 4812 + 4815 O -20.066885 -9.761422 6.553470 402 4816 4817 + 4816 H -20.997945 -9.935159 6.946701 403 4815 + 4817 H -19.442249 -9.796491 7.281455 403 4815 + 4818 O -23.097741 6.873436 -18.392975 402 4819 4820 + 4819 H -22.589483 6.725087 -19.200274 403 4818 + 4820 H -22.785797 7.752769 -18.098029 403 4818 + 4821 O 18.849536 1.746914 0.846251 402 4822 4823 + 4822 H 18.128002 2.129064 0.287715 403 4821 + 4823 H 19.181226 2.420341 1.435040 403 4821 + 4824 O 27.002887 18.923510 11.873786 402 4825 4826 + 4825 H 27.227664 19.764419 11.414163 403 4824 + 4826 H 26.105946 19.033421 11.984937 403 4824 + 4827 O -11.158512 11.141322 18.442481 402 4828 4829 + 4828 H -11.408050 10.995491 17.540347 403 4827 + 4829 H -10.502213 10.475024 18.734764 403 4827 + 4830 O -21.495790 -1.351514 -4.237645 402 4831 4832 + 4831 H -21.044359 -1.664515 -3.433502 403 4830 + 4832 H -22.384314 -1.671646 -4.060127 403 4830 + 4833 O 15.621755 -15.205139 -2.495677 402 4834 4835 + 4834 H 15.424484 -14.934581 -1.611471 403 4833 + 4835 H 16.121625 -14.529114 -2.853796 403 4833 + 4836 O 4.381992 13.875981 -1.032186 402 4837 4838 + 4837 H 5.333475 13.689707 -0.896179 403 4836 + 4838 H 4.022732 13.223499 -1.665135 403 4836 + 4839 O 20.177887 10.395959 -3.696541 402 4840 4841 + 4840 H 20.356404 10.914845 -4.496586 403 4839 + 4841 H 20.991017 10.244340 -3.211612 403 4839 + 4842 O 15.157815 19.249081 -18.039544 402 4843 4844 + 4843 H 15.352336 20.161425 -17.776001 403 4842 + 4844 H 15.059841 19.346261 -19.002141 403 4842 + 4845 O -7.108984 -13.295157 15.804846 402 4846 4847 + 4846 H -6.929809 -14.169985 15.496547 403 4845 + 4847 H -6.361874 -13.100921 16.402035 403 4845 + 4848 O -25.065030 -11.005040 18.970744 402 4849 4850 + 4849 H -25.902113 -11.429253 18.763963 403 4848 + 4850 H -25.182957 -10.072508 18.787257 403 4848 + 4851 O 11.932413 -6.103636 -13.397989 402 4852 4853 + 4852 H 12.570617 -5.775336 -12.776618 403 4851 + 4853 H 12.223586 -6.926860 -13.765008 403 4851 + 4854 O -25.022964 -4.047632 -16.421532 402 4855 4856 + 4855 H -24.729550 -4.908790 -16.087160 403 4854 + 4856 H -24.546933 -3.445338 -15.856315 403 4854 + 4857 O -2.351505 -13.799895 -9.640381 402 4858 4859 + 4858 H -2.806266 -13.103621 -10.108151 403 4857 + 4859 H -1.432803 -13.498454 -9.473869 403 4857 + 4860 O -17.970640 -1.824370 11.981061 402 4861 4862 + 4861 H -18.720197 -1.276483 12.154733 403 4860 + 4862 H -17.669382 -2.084512 12.859437 403 4860 + 4863 O 16.682335 16.786230 -5.408443 402 4864 4865 + 4864 H 15.963934 17.446355 -5.166695 403 4863 + 4865 H 16.709036 16.877417 -6.391919 403 4863 + 4866 O -26.984415 4.176614 -3.075863 402 4867 4868 + 4867 H -26.123649 4.345106 -2.684692 403 4866 + 4868 H -26.853761 3.725314 -3.913099 403 4866 + 4869 O -26.077892 0.261300 17.719641 402 4870 4871 + 4870 H -26.784019 0.913023 17.543217 403 4869 + 4871 H -26.472468 -0.574255 17.882963 403 4869 + 4872 O 22.927522 20.111945 -15.638008 402 4873 4874 + 4873 H 23.596986 20.008343 -14.934189 403 4872 + 4874 H 22.343012 20.821690 -15.365852 403 4872 + 4875 O -5.579568 -12.021256 13.421129 402 4876 4877 + 4876 H -5.890589 -11.086014 13.250578 403 4875 + 4877 H -6.303487 -12.389144 13.952477 403 4875 + 4878 O 2.458268 -17.079274 7.291369 402 4879 4880 + 4879 H 2.320253 -17.365496 8.234460 403 4878 + 4880 H 1.770368 -16.394030 7.185697 403 4878 + 4881 O -24.595173 -15.448874 14.340370 402 4882 4883 + 4882 H -23.877774 -15.587584 14.998240 403 4881 + 4883 H -25.176320 -14.635721 14.530870 403 4881 + 4884 O 27.032054 -9.403183 3.148273 402 4885 4886 + 4885 H 26.403900 -8.794366 3.626157 403 4884 + 4886 H 27.383095 -9.993711 3.825592 403 4884 + 4887 O -20.726606 14.795856 1.273133 402 4888 4889 + 4888 H -19.806504 14.435167 1.199972 403 4887 + 4889 H -21.276966 14.325769 0.588346 403 4887 + 4890 O -24.967956 8.541628 1.328681 402 4891 4892 + 4891 H -24.984827 9.452469 1.040896 403 4890 + 4892 H -25.740396 8.434977 1.929151 403 4890 + 4893 O -12.425328 11.518457 -14.199688 402 4894 4895 + 4894 H -12.773966 12.392793 -14.015441 403 4893 + 4895 H -13.118630 10.965584 -13.849575 403 4893 + 4896 O -2.529035 -2.360811 17.836544 402 4897 4898 + 4897 H -3.234696 -2.119216 18.386147 403 4896 + 4898 H -1.867440 -1.729883 18.015495 403 4896 + 4899 O -21.776402 4.919177 -10.291667 402 4900 4901 + 4900 H -22.083924 5.863215 -10.349382 403 4899 + 4901 H -22.101633 4.482076 -11.074994 403 4899 + 4902 O 6.293596 15.999990 18.747555 402 4903 4904 + 4903 H 5.792274 16.524552 19.421554 403 4902 + 4904 H 5.641363 15.346197 18.513974 403 4902 + 4905 O 8.520334 14.536496 -17.222476 402 4906 4907 + 4906 H 9.367910 14.362425 -16.812169 403 4905 + 4907 H 8.183656 13.684606 -17.523424 403 4905 + 4908 O 22.691056 10.129741 -9.774947 402 4909 4910 + 4909 H 22.388373 10.989892 -9.545078 403 4908 + 4910 H 23.520258 10.122274 -10.228776 403 4908 + 4911 O 11.292032 2.127043 14.679028 402 4912 4913 + 4912 H 10.300438 2.012949 14.574584 403 4911 + 4913 H 11.707898 2.382716 13.839204 403 4911 + 4914 O -10.080449 15.590962 -5.638342 402 4915 4916 + 4915 H -9.913581 15.482801 -6.607010 403 4914 + 4916 H -11.000029 15.446049 -5.572110 403 4914 + 4917 O 9.724654 19.017882 -10.687275 402 4918 4919 + 4918 H 10.589720 19.426462 -10.594122 403 4917 + 4919 H 9.112520 19.575919 -10.256988 403 4917 + 4920 O -3.018641 7.588470 16.688095 402 4921 4922 + 4921 H -2.330160 6.909662 16.567035 403 4920 + 4922 H -3.336233 7.572799 15.739189 403 4920 + 4923 O -23.558310 -7.134740 -5.487980 402 4924 4925 + 4924 H -23.265138 -7.142827 -4.583180 403 4923 + 4925 H -23.745933 -6.250685 -5.834602 403 4923 + 4926 O 4.226629 15.093702 15.365734 402 4927 4928 + 4927 H 4.100578 14.882406 16.320809 403 4926 + 4928 H 5.174530 15.177349 15.271261 403 4926 + 4929 O -7.236890 20.676688 -13.887599 402 4930 4931 + 4930 H -7.297460 19.771023 -14.250227 403 4929 + 4931 H -6.598431 21.116314 -14.486914 403 4929 + 4932 O 15.815010 1.151652 -17.502222 402 4933 4934 + 4933 H 15.282468 0.557615 -16.965425 403 4932 + 4934 H 15.054480 1.630363 -17.957554 403 4932 + 4935 O -20.408893 -2.203285 -1.832435 402 4936 4937 + 4936 H -20.785863 -1.600728 -1.206934 403 4935 + 4937 H -20.672903 -3.085785 -1.719471 403 4935 + 4938 O 20.195914 -9.732203 -7.503586 402 4939 4940 + 4939 H 19.775594 -9.020266 -6.898678 403 4938 + 4940 H 21.112065 -9.804356 -7.217365 403 4938 + 4941 O 19.296629 -3.381575 11.843745 402 4942 4943 + 4942 H 19.274699 -4.314587 11.989050 403 4941 + 4943 H 20.065392 -3.074363 12.391528 403 4941 + 4944 O 6.531812 13.501627 -15.078637 402 4945 4946 + 4945 H 5.967341 14.060209 -15.705952 403 4944 + 4946 H 6.508026 12.632112 -15.439267 403 4944 + 4947 O 23.589867 -10.343367 -8.571682 402 4948 4949 + 4948 H 23.047931 -10.296334 -7.779151 403 4947 + 4949 H 23.642788 -11.281031 -8.849406 403 4947 + 4950 O -13.933420 -9.985099 16.210161 402 4951 4952 + 4951 H -13.061691 -9.875550 16.658981 403 4950 + 4952 H -13.656103 -10.632088 15.489463 403 4950 + 4953 O -23.237683 18.866731 19.359260 402 4954 4955 + 4954 H -22.914140 19.726873 19.738290 403 4953 + 4955 H -23.718173 18.429834 20.073905 403 4953 + 4956 O 10.494095 4.110524 19.341374 402 4957 4958 + 4957 H 9.723154 4.572616 18.942773 403 4956 + 4958 H 11.209458 4.339646 18.681127 403 4956 + 4959 O 1.369329 -9.441779 19.284078 402 4960 4961 + 4960 H 2.015289 -10.186860 19.212218 403 4959 + 4961 H 1.015324 -9.189016 18.436693 403 4959 + 4962 O -12.121346 16.858305 -16.912154 402 4963 4964 + 4963 H -12.482071 17.717178 -16.927558 403 4962 + 4964 H -11.557811 16.791147 -17.773819 403 4962 + 4965 O -9.672999 19.181029 4.107845 402 4966 4967 + 4966 H -8.970953 19.839775 3.892751 403 4965 + 4967 H -10.347573 19.719934 4.574402 403 4965 + 4968 O -25.848254 19.893856 -6.158583 402 4969 4970 + 4969 H -26.297371 20.306721 -5.458518 403 4968 + 4970 H -25.747309 20.595741 -6.795744 403 4968 + 4971 O -23.033567 -20.060181 19.659192 402 4972 4973 + 4972 H -22.235177 -19.955724 19.067747 403 4971 + 4973 H -23.368334 -19.148619 19.847979 403 4971 + 4974 O -15.791938 8.271699 18.828418 402 4975 4976 + 4975 H -16.027582 7.356294 18.646313 403 4974 + 4976 H -16.655172 8.767091 18.686291 403 4974 + 4977 O -21.708167 13.277512 -0.641646 402 4978 4979 + 4978 H -22.597047 13.562637 -0.909355 403 4977 + 4979 H -21.809236 12.333829 -0.325507 403 4977 + 4980 O 5.941295 -12.360207 -6.112984 402 4981 4982 + 4981 H 6.359630 -11.626042 -5.736075 403 4980 + 4982 H 6.495648 -12.726477 -6.802834 403 4980 + 4983 O 13.032092 -7.701355 -9.994956 402 4984 4985 + 4984 H 13.027162 -8.501577 -10.533994 403 4983 + 4985 H 12.548921 -8.005933 -9.172971 403 4983 + 4986 O -21.030949 -20.119698 18.010996 402 4987 4988 + 4987 H -20.244199 -20.716690 18.012037 403 4986 + 4988 H -20.696565 -19.252737 17.848450 403 4986 + 4989 O -19.015223 -0.571456 18.155941 402 4990 4991 + 4990 H -19.180719 -0.389583 17.176932 403 4989 + 4991 H -18.385462 0.098617 18.394716 403 4989 + 4992 O -20.138485 -4.252628 -11.316573 402 4993 4994 + 4993 H -19.840849 -5.049159 -11.793063 403 4992 + 4994 H -20.052902 -4.580000 -10.382886 403 4992 + 4995 O 26.001968 -7.495414 4.672795 402 4996 4997 + 4996 H 25.441451 -7.324776 5.428706 403 4995 + 4997 H 26.791498 -7.049997 4.959197 403 4995 + 4998 O 19.055181 -8.349517 1.323580 402 4999 5000 + 4999 H 19.813936 -8.781204 1.703347 403 4998 + 5000 H 19.440205 -7.777422 0.589952 403 4998 + 5001 O 25.264798 8.233933 8.591555 402 5002 5003 + 5002 H 25.487528 8.137778 9.540405 403 5001 + 5003 H 25.431397 9.162412 8.389274 403 5001 + 5004 O 12.847916 19.693484 13.048286 402 5005 5006 + 5005 H 11.960267 19.995654 12.950099 403 5004 + 5006 H 13.352276 20.516003 12.895948 403 5004 + 5007 O -1.639765 11.429914 5.808063 402 5008 5009 + 5008 H -1.143950 12.047063 6.360614 403 5007 + 5009 H -2.350791 11.948090 5.492463 403 5007 + 5010 O 9.848758 16.041115 -10.707370 402 5011 5012 + 5011 H 9.065082 15.706216 -11.123228 403 5010 + 5012 H 9.845269 17.025290 -10.747608 403 5010 + 5013 O 25.426954 20.293141 3.300623 402 5014 5015 + 5014 H 25.545358 20.769417 4.152492 403 5013 + 5015 H 25.632270 21.033287 2.715396 403 5013 + 5016 O 20.761109 8.207487 15.638898 402 5017 5018 + 5017 H 20.452100 8.556874 16.455577 403 5016 + 5018 H 20.418491 7.276974 15.507884 403 5016 + 5019 O -17.340920 8.603213 9.973826 402 5020 5021 + 5020 H -17.013776 7.715227 10.202262 403 5019 + 5021 H -17.708959 8.550775 9.106960 403 5019 + 5022 O -4.331343 4.519352 -17.647753 402 5023 5024 + 5023 H -5.066787 3.870671 -17.637369 403 5022 + 5024 H -3.551869 3.998790 -17.434586 403 5022 + 5025 O 20.173773 -17.092486 -7.001341 402 5026 5027 + 5026 H 19.888855 -16.443588 -7.714490 403 5025 + 5027 H 20.413820 -17.900629 -7.443434 403 5025 + 5028 O -24.408814 -19.385733 11.225815 402 5029 5030 + 5029 H -23.821161 -19.917061 10.749392 403 5028 + 5030 H -23.910074 -18.660169 11.617528 403 5028 + 5031 O 17.324633 -1.128975 8.030022 402 5032 5033 + 5032 H 17.360905 -1.837044 8.692495 403 5031 + 5033 H 18.151746 -0.980682 7.588726 403 5031 + 5034 O 23.955106 -0.867756 -15.846487 402 5035 5036 + 5035 H 24.366679 -1.312193 -16.592677 403 5034 + 5036 H 23.040207 -0.721605 -15.963924 403 5034 + 5037 O 9.794322 -16.325238 -14.689703 402 5038 5039 + 5038 H 10.077445 -16.942203 -15.418778 403 5037 + 5039 H 10.274190 -16.591924 -13.896103 403 5037 + 5040 O -19.734101 -12.095151 -17.153284 402 5041 5042 + 5041 H -20.605684 -12.154989 -17.550952 403 5040 + 5042 H -19.490756 -11.177750 -17.393726 403 5040 + 5043 O 2.145542 4.244476 10.559284 402 5044 5045 + 5044 H 1.712137 4.346774 11.448612 403 5043 + 5045 H 1.552348 4.733416 9.969137 403 5043 + 5046 O -11.816250 3.934419 -18.405990 402 5047 5048 + 5047 H -11.103191 4.038219 -19.027130 403 5046 + 5048 H -12.427642 3.303177 -18.846649 403 5046 + 5049 O 18.893576 -19.279190 2.434753 402 5050 5051 + 5050 H 19.835933 -19.611541 2.415682 403 5049 + 5051 H 18.743093 -19.115267 3.373179 403 5049 + 5052 O 20.503855 18.939356 -0.359795 402 5053 5054 + 5053 H 20.047818 18.683781 0.506021 403 5052 + 5054 H 19.907310 19.650581 -0.623461 403 5052 + 5055 O 26.407017 7.546865 -12.797932 402 5056 5057 + 5056 H 25.672384 7.104790 -13.280274 403 5055 + 5057 H 27.091777 7.777455 -13.451817 403 5055 + 5058 O 25.647383 -6.341604 -8.154924 402 5059 5060 + 5059 H 26.357304 -5.715813 -8.365206 403 5058 + 5060 H 25.997425 -7.137628 -8.663351 403 5058 + 5061 O 24.828979 0.493040 8.418984 402 5062 5063 + 5062 H 25.575762 0.370102 9.128898 403 5061 + 5063 H 24.779810 -0.342584 8.014099 403 5061 + 5064 O 17.019067 17.317670 3.445072 402 5065 5066 + 5065 H 16.246945 17.951681 3.647617 403 5064 + 5066 H 17.118513 16.924515 4.354268 403 5064 + 5067 O -14.811273 -9.813473 19.349487 402 5068 5069 + 5068 H -15.258466 -10.583929 19.669257 403 5067 + 5069 H -14.033228 -10.041012 18.847205 403 5067 + 5070 O 23.382015 -15.215511 6.306360 402 5071 5072 + 5071 H 24.055596 -14.464366 6.446483 403 5070 + 5072 H 22.714188 -14.794741 5.753275 403 5070 + 5073 O -26.337628 -13.401476 1.412480 402 5074 5075 + 5074 H -26.098445 -12.489264 1.304520 403 5073 + 5075 H -25.434229 -13.739613 1.185013 403 5073 + 5076 O 12.045641 6.334478 14.034491 402 5077 5078 + 5077 H 11.290237 6.052909 13.448299 403 5076 + 5078 H 12.782332 5.993917 13.490639 403 5076 + 5079 O 20.125812 -8.202150 -9.814098 402 5080 5081 + 5080 H 20.194536 -8.887766 -9.162911 403 5079 + 5081 H 21.027215 -8.057148 -10.044296 403 5079 + 5082 O 12.066525 -8.540938 -7.364209 402 5083 5084 + 5083 H 11.508583 -8.030746 -6.799426 403 5082 + 5084 H 11.560454 -9.411302 -7.497328 403 5082 + 5085 O 6.006584 -19.643391 -16.856771 402 5086 5087 + 5086 H 5.834004 -19.490315 -17.723180 403 5085 + 5087 H 5.173445 -19.306940 -16.418662 403 5085 + 5088 O -26.105240 9.497668 11.035009 402 5089 5090 + 5089 H -25.940506 10.208588 11.676762 403 5088 + 5090 H -26.907023 9.839249 10.688906 403 5088 + 5091 O 25.980779 -10.760099 -17.043079 402 5092 5093 + 5092 H 26.294152 -9.947887 -17.408944 403 5091 + 5093 H 26.659719 -11.433214 -17.294305 403 5091 + 5094 O 17.405056 -19.269747 -14.944723 402 5095 5096 + 5095 H 17.214410 -18.409556 -14.434720 403 5094 + 5096 H 17.526094 -19.972476 -14.301658 403 5094 + 5097 O -24.018604 17.625199 1.640879 402 5098 5099 + 5098 H -24.784080 17.611175 1.083900 403 5097 + 5099 H -24.038354 18.437262 2.233960 403 5097 + 5100 O -19.713596 9.725034 11.241378 402 5101 5102 + 5101 H -20.334881 9.562447 10.458947 403 5100 + 5102 H -18.859792 9.431551 10.874150 403 5100 + 5103 O 12.017227 10.801952 4.275634 402 5104 5105 + 5104 H 11.431320 10.637434 5.045035 403 5103 + 5105 H 11.407446 10.560420 3.532631 403 5103 + 5106 O -2.032321 -18.778706 7.677870 402 5107 5108 + 5107 H -1.174746 -18.822855 7.226095 403 5106 + 5108 H -2.302104 -17.849324 7.787431 403 5106 + 5109 O 27.376193 5.800091 -18.808667 402 5110 5111 + 5110 H 28.217784 5.560939 -18.324424 403 5109 + 5111 H 27.470430 6.797809 -18.833583 403 5109 + 5112 O 22.777052 -4.203723 15.528690 402 5113 5114 + 5113 H 22.819825 -4.163457 14.596219 403 5112 + 5114 H 23.290333 -4.967303 15.841471 403 5112 + 5115 O -24.407041 -11.771935 -2.162786 402 5116 5117 + 5116 H -24.850114 -12.297116 -2.844402 403 5115 + 5117 H -24.335332 -10.842961 -2.448771 403 5115 + 5118 O 26.515383 14.863308 -11.949090 402 5119 5120 + 5119 H 25.693505 15.247676 -11.698157 403 5118 + 5120 H 27.137639 14.903509 -11.237657 403 5118 + 5121 O 9.526170 19.544584 -4.495947 402 5122 5123 + 5122 H 8.563440 19.681938 -4.310177 403 5121 + 5123 H 9.710873 20.389152 -4.948099 403 5121 + 5124 O 0.930640 14.865621 2.693375 402 5125 5126 + 5125 H 1.441052 15.216977 2.015262 403 5124 + 5126 H 0.982855 15.427541 3.521397 403 5124 + 5127 O -8.560884 -14.779791 -0.317309 402 5128 5129 + 5128 H -7.563132 -14.724309 -0.578447 403 5127 + 5129 H -8.944725 -15.346794 -1.006948 403 5127 + 5130 O -7.319722 -18.863858 -20.528347 402 5131 5132 + 5131 H -8.028502 -18.663258 -21.126375 403 5130 + 5132 H -7.164500 -19.772394 -20.500444 403 5130 + 5133 O -15.128995 -19.691380 3.092730 402 5134 5135 + 5134 H -16.008789 -19.690772 3.472840 403 5133 + 5135 H -14.968322 -20.623238 2.789294 403 5133 + 5136 O 14.985700 14.931491 -8.447163 402 5137 5138 + 5137 H 15.394555 15.826269 -8.282486 403 5136 + 5138 H 14.583931 14.705829 -7.592039 403 5136 + 5139 O 27.322481 11.495061 -9.977404 402 5140 5141 + 5140 H 26.863175 12.062729 -9.353442 403 5139 + 5141 H 28.126888 11.829690 -10.258173 403 5139 + 5142 O -18.229397 7.978168 7.639376 402 5143 5144 + 5143 H -19.028971 7.438874 7.807107 403 5142 + 5144 H -17.575997 7.370338 7.232298 403 5142 + 5145 O -5.554901 9.643950 18.209130 402 5146 5147 + 5146 H -4.877908 10.197790 17.765078 403 5145 + 5147 H -5.709375 10.290933 18.919059 403 5145 + 5148 O 27.055810 -8.039157 10.769461 402 5149 5150 + 5149 H 27.007722 -8.570107 10.005081 403 5148 + 5150 H 26.186325 -7.596689 10.673325 403 5148 + 5151 O 11.193144 -4.443017 6.826722 402 5152 5153 + 5152 H 10.836891 -3.569010 6.720665 403 5151 + 5153 H 12.137206 -4.292318 6.939554 403 5151 + 5154 O 19.268222 19.404109 -20.005983 402 5155 5156 + 5155 H 18.552307 19.427583 -20.612317 403 5154 + 5156 H 20.054546 19.443947 -20.508778 403 5154 + 5157 O -0.489608 2.918279 -19.339493 402 5158 5159 + 5158 H -0.728227 3.023881 -20.237208 403 5157 + 5159 H 0.435524 3.253135 -19.140478 403 5157 + 5160 O -9.930055 10.868000 -17.673601 402 5161 5162 + 5161 H -10.626469 11.466271 -17.943644 403 5160 + 5162 H -9.408670 11.199903 -16.908283 403 5160 + 5163 O 14.391665 -7.492360 -17.133433 402 5164 5165 + 5164 H 14.776095 -6.640715 -16.914336 403 5163 + 5165 H 14.844935 -7.826758 -17.919613 403 5163 + 5166 O -4.403090 17.562294 4.304967 402 5167 5168 + 5167 H -3.639926 17.895809 4.788467 403 5166 + 5168 H -4.847822 18.247386 3.881416 403 5166 + 5169 O 14.924216 -8.572989 -7.802421 402 5170 5171 + 5170 H 15.080791 -9.001730 -8.577899 403 5169 + 5171 H 14.072292 -8.888256 -7.443501 403 5169 + 5172 O 20.863060 -8.335281 -2.996473 402 5173 5174 + 5173 H 20.865038 -7.834818 -2.195694 403 5172 + 5174 H 20.360014 -9.121641 -2.844384 403 5172 + 5175 O 7.770701 4.749626 -15.173810 402 5176 5177 + 5176 H 7.232605 4.918984 -14.407401 403 5175 + 5177 H 7.150893 4.735931 -15.889673 403 5175 + 5178 O 9.287502 -20.421293 -19.615918 402 5179 5180 + 5179 H 8.673901 -19.918813 -20.140368 403 5178 + 5180 H 10.257214 -20.289398 -19.904230 403 5178 + 5181 O 20.543914 -3.694600 8.858562 402 5182 5183 + 5182 H 20.350529 -3.346561 9.790355 403 5181 + 5183 H 20.284447 -4.620852 8.950478 403 5181 + 5184 O -24.889469 -2.826087 -11.161559 402 5185 5186 + 5185 H -24.617642 -1.952238 -10.677372 403 5184 + 5186 H -25.879679 -2.907043 -11.066325 403 5184 + 5187 O 16.046200 -19.874001 -17.403642 402 5188 5189 + 5188 H 16.633402 -19.935906 -18.189298 403 5187 + 5189 H 16.556861 -19.594522 -16.612102 403 5187 + 5190 O 5.741718 -12.703855 14.460309 402 5191 5192 + 5191 H 6.418646 -13.226075 14.848859 403 5190 + 5192 H 5.375423 -12.291966 15.251474 403 5190 + 5193 O -26.921124 3.080708 -16.683288 402 5194 5195 + 5194 H -26.349288 3.764354 -17.076383 403 5193 + 5195 H -27.310492 3.610598 -15.940909 403 5193 + 5196 O -9.051861 -12.598891 -10.481740 402 5197 5198 + 5197 H -9.312975 -13.202994 -11.160740 403 5196 + 5198 H -9.863453 -12.002119 -10.435649 403 5196 + 5199 O 11.222934 -19.072403 -5.120308 402 5200 5201 + 5200 H 10.662322 -18.478568 -5.660022 403 5199 + 5201 H 12.014749 -19.325909 -5.638718 403 5199 + 5202 O 18.944446 -1.761496 -1.989981 402 5203 5204 + 5203 H 19.143872 -2.715939 -1.959282 403 5202 + 5204 H 18.884717 -1.422297 -1.082916 403 5202 + 5205 O 23.550316 -15.829708 -20.623087 402 5206 5207 + 5206 H 22.847013 -15.261005 -20.962532 403 5205 + 5207 H 23.291254 -16.269725 -19.776352 403 5205 + 5208 O 16.851801 5.388343 15.856452 402 5209 5210 + 5209 H 16.397949 5.383405 15.017945 403 5208 + 5210 H 16.364224 6.131529 16.215918 403 5208 + 5211 O 12.029283 -15.298450 15.005226 402 5212 5213 + 5212 H 11.752968 -15.998705 15.556968 403 5211 + 5213 H 11.367704 -14.915688 14.430927 403 5211 + 5214 O 14.340396 -0.486882 2.372215 402 5215 5216 + 5215 H 13.663877 -0.866715 2.885453 403 5214 + 5216 H 14.313669 0.446574 2.655905 403 5214 + 5217 O -4.590564 -6.037942 9.321481 402 5218 5219 + 5218 H -4.191484 -6.200341 8.445394 403 5217 + 5219 H -4.057284 -5.373615 9.813704 403 5217 + 5220 O 11.373242 -19.244304 -15.042581 402 5221 5222 + 5221 H 12.222601 -19.509329 -15.419988 403 5220 + 5222 H 10.727440 -19.492586 -15.694712 403 5220 + 5223 O 8.445009 -7.353337 -20.644303 402 5224 5225 + 5224 H 8.065671 -6.779925 -19.985343 403 5223 + 5225 H 8.109658 -8.330016 -20.463794 403 5223 + 5226 O 9.428901 8.662531 -17.428301 402 5227 5228 + 5227 H 8.456111 8.645724 -17.644511 403 5226 + 5228 H 9.529146 9.218358 -16.645571 403 5226 + 5229 O -22.387040 -19.582592 -7.404304 402 5230 5231 + 5230 H -22.537521 -18.739332 -7.873166 403 5229 + 5231 H -22.150442 -19.339940 -6.528223 403 5229 + 5232 O 26.735971 -15.726321 7.121648 402 5233 5234 + 5233 H 25.953722 -16.106883 7.512069 403 5232 + 5234 H 26.460359 -14.804570 6.934323 403 5232 + 5235 O -20.988572 11.929476 3.968066 402 5236 5237 + 5236 H -21.340596 11.563124 4.784938 403 5235 + 5237 H -21.130650 12.884161 4.069043 403 5235 + 5238 O 21.473005 20.923952 -4.710755 402 5239 5240 + 5239 H 22.324172 21.375208 -4.753044 403 5238 + 5240 H 21.707980 20.020307 -4.884522 403 5238 + 5241 O 18.479193 -0.888136 0.672743 402 5242 5243 + 5242 H 17.536329 -0.750808 0.451811 403 5241 + 5243 H 18.753176 -0.016644 0.847545 403 5241 + 5244 O -13.644220 -0.195942 -16.728164 402 5245 5246 + 5245 H -14.145608 -0.971886 -16.514909 403 5244 + 5246 H -13.412704 -0.294150 -17.655379 403 5244 + 5247 O -27.356282 -13.782004 3.934427 402 5248 5249 + 5248 H -27.242980 -13.845896 2.900565 403 5247 + 5249 H -28.015991 -14.339318 4.193014 403 5247 + 5250 O 18.276550 10.521821 -10.411508 402 5251 5252 + 5251 H 17.466149 10.037966 -10.334512 403 5250 + 5252 H 18.135131 11.463023 -10.441937 403 5250 + 5253 O 11.304676 -3.958739 14.771873 402 5254 5255 + 5254 H 10.819571 -4.657592 14.338362 403 5253 + 5255 H 11.872243 -4.302988 15.497743 403 5253 + 5256 O 0.810718 18.132291 -14.333312 402 5257 5258 + 5257 H 0.190255 17.471051 -14.607576 403 5256 + 5258 H 1.665202 17.681600 -14.166677 403 5256 + 5259 O -18.194302 10.734237 20.288216 402 5260 5261 + 5260 H -18.737476 10.008872 20.011140 403 5259 + 5261 H -18.413412 10.870765 21.217524 403 5259 + 5262 O -7.563142 -16.389647 8.034997 402 5263 5264 + 5263 H -7.754897 -16.237987 7.073421 403 5262 + 5264 H -8.386855 -16.715419 8.384876 403 5262 + 5265 O 13.912058 -6.782117 15.996328 402 5266 5267 + 5266 H 13.180027 -7.276194 16.277557 403 5265 + 5267 H 13.861231 -6.438577 15.112401 403 5265 + 5268 O -25.429958 -6.548345 16.184656 402 5269 5270 + 5269 H -24.780220 -7.006450 16.697079 403 5268 + 5270 H -26.340485 -6.934525 16.332424 403 5268 + 5271 O -25.500783 -16.025799 -9.490569 402 5272 5273 + 5272 H -26.164448 -16.158413 -8.820769 403 5271 + 5273 H -25.951236 -16.456932 -10.263221 403 5271 + 5274 O 24.124222 2.121712 -16.465144 402 5275 5276 + 5275 H 24.497335 2.845246 -17.081218 403 5274 + 5276 H 24.792485 1.399163 -16.373949 403 5274 + 5277 O 4.547327 -7.471124 19.146289 402 5278 5279 + 5278 H 4.354864 -7.322111 18.216109 403 5277 + 5279 H 3.632016 -7.470487 19.500477 403 5277 + 5280 O 10.120616 17.236092 14.316409 402 5281 5282 + 5281 H 10.306027 17.503867 15.195486 403 5280 + 5282 H 9.503499 17.802179 13.861569 403 5280 + 5283 O 21.443686 -0.137574 -7.240239 402 5284 5285 + 5284 H 21.320909 -0.780264 -6.543039 403 5283 + 5285 H 20.520021 0.052046 -7.411757 403 5283 + 5286 O -18.828207 -17.795055 12.603944 402 5287 5288 + 5287 H -19.462622 -18.118613 13.289732 403 5286 + 5288 H -19.239011 -18.165303 11.770846 403 5286 + 5289 O -5.408698 18.602640 19.942387 402 5290 5291 + 5290 H -4.940011 19.368098 19.546138 403 5289 + 5291 H -4.701861 17.940803 20.028319 403 5289 + 5292 O 1.246630 7.058463 14.491223 402 5293 5294 + 5293 H 1.833210 6.855645 13.673367 403 5292 + 5294 H 1.409024 6.330352 15.131330 403 5292 + 5295 O 12.743100 -19.137500 -10.658143 402 5296 5297 + 5296 H 12.731029 -19.861558 -11.325766 403 5295 + 5297 H 13.636140 -18.849862 -10.621111 403 5295 + 5298 O 8.176227 18.621713 -14.093293 402 5299 5300 + 5299 H 8.403415 17.666902 -14.107193 403 5298 + 5300 H 8.904018 18.994347 -14.634670 403 5298 + 5301 O -2.850169 -13.873152 15.306117 402 5302 5303 + 5302 H -2.778021 -14.417883 14.515219 403 5301 + 5303 H -2.855607 -12.985119 14.927436 403 5301 + 5304 O -2.292558 -20.012333 10.080992 402 5305 5306 + 5305 H -1.651194 -19.572426 10.625999 403 5304 + 5306 H -2.187742 -19.593458 9.218576 403 5304 + 5307 O 22.331247 5.799873 2.670280 402 5308 5309 + 5308 H 22.434189 5.666649 3.628261 403 5307 + 5309 H 22.776307 5.021312 2.347574 403 5307 + 5310 O 15.417762 16.217823 -20.022192 402 5311 5312 + 5311 H 14.476316 16.148202 -19.889414 403 5310 + 5312 H 15.596696 16.629517 -20.930968 403 5310 + 5313 O -26.290384 -0.615609 -8.011370 402 5314 5315 + 5314 H -26.337180 -1.338819 -7.375398 403 5313 + 5315 H -27.197456 -0.506091 -8.331222 403 5313 + 5316 O 9.027104 -10.649673 18.216586 402 5317 5318 + 5317 H 9.003116 -9.685060 18.321463 403 5316 + 5318 H 8.395635 -11.040516 18.879208 403 5316 + 5319 O 20.540085 20.400943 18.176526 402 5320 5321 + 5320 H 21.096121 20.661895 18.908831 403 5319 + 5321 H 19.896888 21.145098 18.113813 403 5319 + 5322 O -1.026820 14.710767 -4.091506 402 5323 5324 + 5323 H -1.483470 15.499879 -3.851169 403 5322 + 5324 H -1.334746 14.285611 -4.859625 403 5322 + 5325 O -26.089489 15.380454 18.855264 402 5326 5327 + 5326 H -25.115552 15.260124 18.557693 403 5325 + 5327 H -26.107913 15.393677 19.825673 403 5325 + 5328 O 2.007574 -16.086893 18.910154 402 5329 5330 + 5329 H 2.169938 -15.300051 18.371811 403 5328 + 5330 H 1.765349 -16.777501 18.309170 403 5328 + 5331 O -1.731416 -1.209658 -17.616026 402 5332 5333 + 5332 H -1.627324 -2.121913 -17.876677 403 5331 + 5333 H -0.897064 -0.759027 -17.856313 403 5331 + 5334 O -7.458988 -9.905611 -19.067646 402 5335 5336 + 5335 H -7.612323 -9.236466 -18.379766 403 5334 + 5336 H -6.775597 -10.433737 -18.660285 403 5334 + 5337 O 24.628885 -15.762187 -8.892475 402 5338 5339 + 5338 H 24.465618 -16.362594 -8.154270 403 5337 + 5339 H 25.428263 -15.265529 -8.789821 403 5337 + 5340 O 21.341678 17.087622 -2.433709 402 5341 5342 + 5341 H 22.027154 16.590055 -2.017304 403 5340 + 5342 H 20.972791 17.595736 -1.703682 403 5340 + 5343 O 11.041731 -1.458544 17.027146 402 5344 5345 + 5344 H 11.616990 -0.777488 17.323484 403 5343 + 5345 H 11.529032 -2.030322 16.345409 403 5343 + 5346 O 20.352182 -20.640448 -2.038220 402 5347 5348 + 5347 H 20.706451 -20.927732 -2.854198 403 5346 + 5348 H 21.078721 -20.655585 -1.410115 403 5346 + 5349 O 2.118915 -12.215325 -19.313844 402 5350 5351 + 5350 H 1.412292 -12.890446 -19.223921 403 5349 + 5351 H 2.971726 -12.642687 -19.466619 403 5349 + 5352 O -18.234007 -11.608978 -6.453902 402 5353 5354 + 5353 H -18.824060 -11.919205 -5.748304 403 5352 + 5354 H -17.399503 -12.148958 -6.321644 403 5352 + 5355 O 12.956287 4.319222 -3.994225 402 5356 5357 + 5356 H 12.213046 3.674862 -3.908399 403 5355 + 5357 H 12.579678 5.119154 -3.559136 403 5355 + 5358 O -16.653199 5.258818 18.455342 402 5359 5360 + 5359 H -17.496007 5.121615 18.892108 403 5358 + 5360 H -16.041443 5.030868 19.126227 403 5358 + 5361 O 10.499124 9.233410 -20.179160 402 5362 5363 + 5362 H 10.147585 9.358107 -19.280974 403 5361 + 5363 H 11.442853 9.276973 -20.041862 403 5361 + 5364 O 0.510441 -0.870953 17.320417 402 5365 5366 + 5365 H 1.102755 -1.566191 17.515002 403 5364 + 5366 H 0.955429 -0.019852 17.557716 403 5364 + 5367 O 4.110276 5.067141 6.431077 402 5368 5369 + 5368 H 4.761963 4.437776 6.681941 403 5367 + 5369 H 4.337595 5.795548 6.948690 403 5367 + 5370 O 11.452671 -16.505838 0.173069 402 5371 5372 + 5371 H 11.303683 -15.607972 0.510340 403 5370 + 5372 H 12.391250 -16.653982 0.330533 403 5370 + 5373 O 7.430077 -20.350208 8.105888 402 5374 5375 + 5374 H 7.675587 -20.672677 7.187383 403 5373 + 5375 H 8.248925 -20.047358 8.520026 403 5373 + 5376 O -7.400434 16.364237 -16.666884 402 5377 5378 + 5377 H -8.382471 16.160840 -16.727806 403 5376 + 5378 H -7.133812 16.815236 -17.541828 403 5376 + 5379 O -24.060814 19.512535 -2.061658 402 5380 5381 + 5380 H -23.130977 19.418843 -1.893643 403 5379 + 5381 H -24.267554 20.363324 -2.551066 403 5379 + 5382 O 20.387077 -17.871252 -2.506384 402 5383 5384 + 5383 H 19.459013 -17.739929 -2.640716 403 5382 + 5384 H 20.424417 -18.802885 -2.422640 403 5382 + 5385 O -9.102927 -20.662897 -0.744511 402 5386 5387 + 5386 H -8.351458 -20.647416 -0.154773 403 5385 + 5387 H -8.808769 -19.943254 -1.313754 403 5385 + 5388 O -22.416841 -13.711743 -11.454147 402 5389 5390 + 5389 H -22.023904 -14.600414 -11.267420 403 5388 + 5390 H -21.766795 -13.100859 -11.064675 403 5388 + 5391 O 18.020659 1.320207 -14.873666 402 5392 5393 + 5392 H 17.072103 1.602050 -14.789845 403 5391 + 5393 H 18.329426 1.503733 -13.971877 403 5391 + 5394 O -15.611967 -16.933927 -20.034244 402 5395 5396 + 5395 H -15.697544 -15.974880 -19.912529 403 5394 + 5396 H -16.463764 -17.241305 -19.666078 403 5394 + 5397 O -21.399563 -20.604313 -19.819242 402 5398 5399 + 5398 H -22.286272 -20.451053 -20.149900 403 5397 + 5399 H -20.960242 -19.767241 -20.062136 403 5397 + 5400 O -14.873799 15.000585 15.755334 402 5401 5402 + 5401 H -15.665375 14.566463 15.276438 403 5400 + 5402 H -15.221469 15.704608 16.223975 403 5400 + 5403 O -22.283717 17.924070 6.363117 402 5404 5405 + 5404 H -22.326943 17.328611 7.088360 403 5403 + 5405 H -22.769780 17.540247 5.616208 403 5403 + 5406 O -4.518256 15.930815 -10.776370 402 5407 5408 + 5407 H -3.722298 16.148281 -11.175263 403 5406 + 5408 H -4.440115 15.005875 -10.441712 403 5406 + 5409 O 23.829242 -12.577808 -10.269253 402 5410 5411 + 5410 H 23.709620 -12.211859 -11.148216 403 5409 + 5411 H 24.681269 -13.072156 -10.250620 403 5409 + 5412 O 25.052401 -0.262291 -3.629356 402 5413 5414 + 5413 H 25.651051 -0.543026 -4.364585 403 5412 + 5414 H 24.527612 0.474703 -4.021632 403 5412 + 5415 O 14.329934 -16.440730 7.995977 402 5416 5417 + 5416 H 15.030052 -16.157725 7.466301 403 5415 + 5417 H 13.674876 -16.863377 7.389073 403 5415 + 5418 O 17.211657 20.746652 5.342912 402 5419 5420 + 5419 H 17.565761 20.264477 4.651199 403 5418 + 5420 H 17.675222 21.576262 5.214762 403 5418 + 5421 O 18.857835 10.961021 -18.198746 402 5422 5423 + 5422 H 18.582121 10.331224 -18.896135 403 5421 + 5423 H 18.706900 11.843177 -18.451427 403 5421 + 5424 O 7.806576 -0.529506 11.040094 402 5425 5426 + 5425 H 8.004288 -1.400200 11.405855 403 5424 + 5426 H 8.516912 0.066000 11.339425 403 5424 + 5427 O -6.293411 -18.726760 -7.845237 402 5428 5429 + 5428 H -6.910802 -18.996812 -8.589964 403 5427 + 5429 H -5.423066 -18.680010 -8.240732 403 5427 + 5430 O -1.265386 -18.351217 15.342196 402 5431 5432 + 5431 H -0.978536 -17.941389 14.498149 403 5430 + 5432 H -1.776754 -19.060650 14.957444 403 5430 + 5433 O 22.240898 5.630349 9.837319 402 5434 5435 + 5434 H 21.800731 4.901204 9.365178 403 5433 + 5435 H 22.570414 6.163537 9.075972 403 5433 + 5436 O -21.322343 8.388055 9.072770 402 5437 5438 + 5437 H -22.042357 8.964988 9.320991 403 5436 + 5438 H -21.568690 8.084477 8.201200 403 5436 + 5439 O -7.671244 -4.189475 20.344117 402 5440 5441 + 5440 H -7.419567 -4.322104 19.418696 403 5439 + 5441 H -8.363860 -4.824728 20.370282 403 5439 + 5442 O -24.129456 16.739076 10.610161 402 5443 5444 + 5443 H -24.547205 17.167468 11.404792 403 5442 + 5444 H -24.468711 15.757636 10.582819 403 5442 + 5445 O -6.867333 -14.186985 10.119152 402 5446 5447 + 5446 H -6.049023 -14.321450 10.601875 403 5445 + 5447 H -7.023306 -14.804381 9.421465 403 5445 + 5448 O 27.346506 -3.270333 -16.312802 402 5449 5450 + 5449 H 28.255175 -3.592935 -16.275175 403 5448 + 5450 H 27.317511 -2.474622 -16.807450 403 5448 + 5451 O -21.641506 5.727852 -20.459813 402 5452 5453 + 5452 H -22.279373 6.214532 -21.053396 403 5451 + 5453 H -20.775787 6.025886 -20.684218 403 5451 + 5454 O 25.309710 5.144361 4.524619 402 5455 5456 + 5455 H 25.816635 5.036211 5.343240 403 5454 + 5456 H 24.410878 4.895458 4.808645 403 5454 + 5457 O -14.509617 -6.262805 19.159506 402 5458 5459 + 5458 H -14.342716 -6.722944 19.988985 403 5457 + 5459 H -14.602416 -5.323286 19.288859 403 5457 + 5460 O -5.343448 -11.274271 19.025798 402 5461 5462 + 5461 H -4.940638 -11.918950 18.424498 403 5460 + 5462 H -5.498793 -11.715720 19.830266 403 5460 + 5463 O -12.848588 -13.590248 17.033609 402 5464 5465 + 5464 H -13.088575 -13.796556 16.123304 403 5463 + 5465 H -11.991420 -14.074390 17.232742 403 5463 + 5466 O -7.289082 -17.381003 -5.549847 402 5467 5468 + 5467 H -8.038865 -17.962440 -5.504293 403 5466 + 5468 H -6.970028 -17.592513 -6.445260 403 5466 + 5469 O 19.348721 -14.932661 19.813219 402 5470 5471 + 5470 H 19.577232 -15.858745 19.765206 403 5469 + 5471 H 18.713188 -14.720751 20.514547 403 5469 + 5472 O -7.930616 -15.106164 -4.397641 402 5473 5474 + 5473 H -8.445836 -14.519877 -4.885728 403 5472 + 5474 H -7.532499 -15.797439 -4.932460 403 5472 + 5475 O 9.305997 -17.229888 -1.625877 402 5476 5477 + 5476 H 9.781891 -17.999835 -2.038321 403 5475 + 5477 H 10.027236 -16.701835 -1.179404 403 5475 + 5478 O 14.485547 17.913855 14.273541 402 5479 5480 + 5479 H 13.775573 18.190913 13.687091 403 5478 + 5480 H 15.292649 17.853242 13.696917 403 5478 + 5481 O -17.856749 -3.239166 18.728922 402 5482 5483 + 5482 H -18.264266 -2.371813 18.585117 403 5481 + 5483 H -17.320266 -3.326693 17.906655 403 5481 + 5484 O 11.415319 5.923359 -20.462324 402 5485 5486 + 5485 H 12.034713 5.464442 -19.848871 403 5484 + 5486 H 10.982818 5.221175 -20.955049 403 5484 + 5487 O 4.246715 -11.198844 16.227140 402 5488 5489 + 5488 H 4.054406 -10.449224 15.720401 403 5487 + 5489 H 3.729643 -11.076561 16.998845 403 5487 + 5490 O 17.668887 16.010513 -14.839435 402 5491 5492 + 5491 H 17.475048 15.032227 -14.810123 403 5490 + 5492 H 17.201356 16.387530 -15.640949 403 5490 + 5493 O -18.492111 8.644500 -1.484673 402 5494 5495 + 5494 H -18.325091 9.560921 -1.252627 403 5493 + 5495 H -19.325787 8.367546 -1.121513 403 5493 + 5496 O 13.610401 12.947630 3.013371 402 5497 5498 + 5497 H 13.281039 12.533993 3.856655 403 5496 + 5498 H 14.367204 13.456810 3.354976 403 5496 + 5499 O -16.423725 20.151070 -20.282392 402 5500 5501 + 5500 H -15.764964 20.343494 -20.952998 403 5499 + 5501 H -17.250142 20.198658 -20.732026 403 5499 + 5502 O -3.989847 10.270724 -11.073966 402 5503 5504 + 5503 H -3.495466 11.034119 -11.283995 403 5502 + 5504 H -4.624991 10.165649 -11.788271 403 5502 + 5505 O 16.276806 2.440391 -0.575792 402 5506 5507 + 5506 H 15.765940 1.689695 -0.443195 403 5505 + 5507 H 16.230870 2.461846 -1.548388 403 5505 + 5508 O 16.582337 4.961920 -0.018366 402 5509 5510 + 5509 H 16.750405 4.953804 0.881833 403 5508 + 5510 H 16.382476 4.092139 -0.296219 403 5508 + 5511 O -16.776801 -4.258809 -20.926631 402 5512 5513 + 5512 H -16.876778 -3.694234 -21.711494 403 5511 + 5513 H -15.815010 -4.231038 -20.634779 403 5511 + 5514 O 27.306315 1.909319 15.774251 402 5515 5516 + 5515 H 27.528797 1.213633 15.174474 403 5514 + 5516 H 26.309168 1.894233 15.827646 403 5514 + 5517 O -25.977063 12.434586 -4.101907 402 5518 5519 + 5518 H -25.419677 13.227991 -4.057872 403 5517 + 5519 H -25.558038 11.886611 -3.392245 403 5517 + 5520 O -8.917537 20.162429 18.906910 402 5521 5522 + 5521 H -9.817722 20.516050 18.889155 403 5520 + 5522 H -8.402992 20.765622 18.322054 403 5520 + 5523 O 2.036338 -3.225452 18.493289 402 5524 5525 + 5524 H 2.815627 -3.223614 19.047224 403 5523 + 5525 H 1.451253 -3.554309 19.176609 403 5523 + 5526 O -10.943111 -16.939296 -15.943963 402 5527 5528 + 5527 H -10.715338 -17.873691 -15.814810 403 5526 + 5528 H -11.411581 -16.839878 -16.774067 403 5526 + 5529 O 5.983465 -15.296272 4.531445 402 5530 5531 + 5530 H 6.553908 -14.747320 5.130885 403 5529 + 5531 H 6.297291 -16.216179 4.672680 403 5529 + 5532 O 0.087877 -18.701863 10.933978 402 5533 5534 + 5533 H 0.685292 -18.178478 10.372593 403 5532 + 5534 H 0.721975 -19.147274 11.528158 403 5532 + 5535 O -15.867197 20.628171 12.879631 402 5536 5537 + 5536 H -14.941749 20.909539 13.127416 403 5535 + 5537 H -16.061214 21.005786 12.011063 403 5535 + 5538 O -15.031464 -1.955849 18.854814 402 5539 5540 + 5539 H -15.381408 -1.375187 18.132775 403 5538 + 5540 H -15.567308 -1.774457 19.596007 403 5538 + 5541 O -5.713639 -18.898958 -11.393727 402 5542 5543 + 5542 H -5.561092 -18.122829 -11.901780 403 5541 + 5543 H -5.027945 -19.039448 -10.715374 403 5541 + 5544 O 10.351785 2.342628 9.137608 402 5545 5546 + 5545 H 10.219354 1.517524 8.764529 403 5544 + 5546 H 9.579584 2.957546 9.024779 403 5544 + 5547 O 9.614533 -0.976089 19.746830 402 5548 5549 + 5548 H 9.631955 -1.223467 18.785924 403 5547 + 5549 H 10.037560 -1.819567 20.145752 403 5547 + 5550 O -25.737514 5.101092 17.496072 402 5551 5552 + 5551 H -25.949189 4.771339 16.619275 403 5550 + 5552 H -25.460497 6.029342 17.333464 403 5550 + 5553 O 27.098530 15.410179 3.235558 402 5554 5555 + 5554 H 27.365221 16.280617 3.273489 403 5553 + 5555 H 27.777628 14.851248 3.682250 403 5553 + 5556 O -22.145578 -2.524811 -16.789026 402 5557 5558 + 5557 H -22.476890 -1.687774 -16.973175 403 5556 + 5558 H -22.545487 -2.678464 -15.881093 403 5556 + 5559 O -20.038660 7.882073 -10.677168 402 5560 5561 + 5560 H -20.786353 8.456789 -10.411968 403 5559 + 5561 H -20.303885 6.997195 -10.661212 403 5559 + 5562 O 6.124673 -5.149502 -15.761404 402 5563 5564 + 5563 H 6.612667 -4.434874 -15.249053 403 5562 + 5564 H 6.646658 -5.246066 -16.553355 403 5562 + 5565 O 6.017362 -16.085801 -17.806752 402 5566 5567 + 5566 H 6.270539 -16.458116 -16.921098 403 5565 + 5567 H 5.250388 -15.542937 -17.506389 403 5565 + 5568 O -9.374031 -17.523242 2.545572 402 5569 5570 + 5569 H -8.487532 -17.678151 2.185352 403 5568 + 5570 H -9.361698 -17.695772 3.484410 403 5568 + 5571 O 15.510564 11.705332 -9.223052 402 5572 5573 + 5572 H 15.764354 12.551003 -8.768718 403 5571 + 5573 H 14.956013 11.971918 -9.941944 403 5571 + 5574 O -8.575937 17.703676 -4.431665 402 5575 5576 + 5575 H -8.405924 17.883222 -3.539392 403 5574 + 5576 H -8.969679 16.778001 -4.495229 403 5574 + 5577 O -15.277037 20.916980 18.527990 402 5578 5579 + 5578 H -14.557049 20.578200 18.029786 403 5577 + 5579 H -14.784644 21.516499 19.154300 403 5577 + 5580 O 23.805081 -13.876618 -5.245218 402 5581 5582 + 5581 H 23.301003 -14.539959 -4.743943 403 5580 + 5582 H 23.699048 -13.156658 -4.566103 403 5580 + 5583 O 23.235009 0.659798 -11.019427 402 5584 5585 + 5584 H 23.356235 -0.020938 -10.331928 403 5583 + 5585 H 23.922180 0.433479 -11.687400 403 5583 + 5586 O -17.846164 6.890268 -13.615475 402 5587 5588 + 5587 H -18.227474 6.233852 -12.960353 403 5586 + 5588 H -17.502560 7.653333 -13.062645 403 5586 + 5589 O 3.237690 6.611110 12.384611 402 5590 5591 + 5590 H 2.939622 6.791701 11.472608 403 5589 + 5591 H 3.597050 5.706217 12.314107 403 5589 + 5592 O 12.621261 19.151311 -10.788464 402 5593 5594 + 5593 H 12.568861 18.191071 -10.482080 403 5592 + 5594 H 12.304890 19.095240 -11.710548 403 5592 + 5595 O 15.189541 -3.590616 -0.359174 402 5596 5597 + 5596 H 15.402717 -3.225037 -1.223302 403 5595 + 5597 H 15.977001 -4.068104 -0.090059 403 5595 + 5598 O -5.355594 -8.568333 19.641427 402 5599 5600 + 5599 H -6.310615 -8.510356 19.969721 403 5598 + 5600 H -5.329970 -9.512642 19.277800 403 5598 + 5601 O 6.365722 2.783749 -12.009649 402 5602 5603 + 5602 H 6.365749 3.750417 -12.183807 403 5601 + 5603 H 5.965929 2.688579 -11.148102 403 5601 + 5604 O 13.169614 -10.142007 -11.634557 402 5605 5606 + 5605 H 12.793149 -9.899166 -12.523960 403 5604 + 5606 H 12.998542 -11.088881 -11.478349 403 5604 + 5607 O -22.674956 -9.666699 -16.999652 402 5608 5609 + 5608 H -22.331812 -10.389941 -17.591652 403 5607 + 5609 H -22.299353 -8.906035 -17.478779 403 5607 + 5610 O -12.989714 14.562837 -4.489024 402 5611 5612 + 5611 H -13.895012 14.141511 -4.581855 403 5610 + 5612 H -12.287469 13.906583 -4.558336 403 5610 + 5613 O 11.889244 7.234465 -14.239933 402 5614 5615 + 5614 H 11.841540 6.403022 -13.699089 403 5613 + 5615 H 11.297036 7.163549 -15.011709 403 5613 + 5616 O 14.205425 -4.375072 6.885349 402 5617 5618 + 5617 H 14.444785 -3.467494 6.828421 403 5616 + 5618 H 14.540396 -4.824463 6.047265 403 5616 + 5619 O 14.238877 -11.199937 -5.844240 402 5620 5621 + 5620 H 14.336897 -11.151845 -6.791045 403 5619 + 5621 H 14.161965 -12.124432 -5.730368 403 5619 + 5622 O 16.419881 -8.263494 5.499713 402 5623 5624 + 5623 H 16.888087 -7.438031 5.380531 403 5622 + 5624 H 16.938306 -8.794006 4.823282 403 5622 + 5625 O 23.034740 17.150944 7.848428 402 5626 5627 + 5626 H 22.252785 17.491282 7.376162 403 5625 + 5627 H 23.353461 18.012155 8.262400 403 5625 + 5628 O -3.250988 20.899767 -14.198279 402 5629 5630 + 5629 H -3.536111 20.593819 -13.311678 403 5628 + 5630 H -2.238291 20.969313 -14.122183 403 5628 + 5631 O 2.193864 -14.308738 -13.102332 402 5632 5633 + 5632 H 2.901120 -13.646677 -13.123464 403 5631 + 5633 H 2.577942 -14.916050 -13.753214 403 5631 + 5634 O 17.220878 14.344503 7.704982 402 5635 5636 + 5635 H 16.741444 14.217801 8.575501 403 5634 + 5636 H 17.724190 13.489371 7.542738 403 5634 + 5637 O 12.455324 8.941935 14.709279 402 5638 5639 + 5638 H 12.329532 7.965607 14.651692 403 5637 + 5639 H 13.090154 8.950686 15.466000 403 5637 + 5640 O -12.573656 -3.849306 9.754915 402 5641 5642 + 5641 H -11.774505 -4.059630 10.198532 403 5640 + 5642 H -13.177238 -3.385101 10.384533 403 5640 + 5643 O -3.160920 -11.557605 -13.637501 402 5644 5645 + 5644 H -3.513108 -10.729378 -13.902906 403 5643 + 5645 H -2.423129 -11.640209 -14.202523 403 5643 + 5646 O 0.173291 18.530627 4.588870 402 5647 5648 + 5647 H 0.366643 18.095665 3.775805 403 5646 + 5648 H 0.528197 17.966406 5.256043 403 5646 + 5649 O -20.835824 0.618182 3.010345 402 5650 5651 + 5650 H -21.714394 0.910710 2.556806 403 5649 + 5651 H -20.176134 1.018899 2.465288 403 5649 + 5652 O -5.819679 17.244537 -18.746988 402 5653 5654 + 5653 H -4.895225 17.522561 -18.912967 403 5652 + 5654 H -5.875069 16.339088 -19.152521 403 5652 + 5655 O 23.150756 6.504841 -18.289508 402 5656 5657 + 5656 H 23.185422 7.145655 -19.092606 403 5655 + 5657 H 22.256620 6.278150 -18.023232 403 5655 + 5658 O 11.077729 -17.823438 -12.637425 402 5659 5660 + 5659 H 11.305129 -18.418523 -13.399570 403 5658 + 5660 H 11.718877 -18.045413 -11.962474 403 5658 + 5661 O -18.440076 4.089219 -20.233130 402 5662 5663 + 5662 H -18.592368 4.508225 -19.389005 403 5661 + 5663 H -18.684565 4.808320 -20.850382 403 5661 + 5664 O -23.687711 -16.266769 -17.315735 402 5665 5666 + 5665 H -23.698996 -15.631059 -16.558060 403 5664 + 5666 H -22.895860 -16.803598 -17.114489 403 5664 + 5667 O -12.383477 -18.880969 14.766217 402 5668 5669 + 5668 H -12.124554 -18.562567 13.876588 403 5667 + 5669 H -11.797092 -18.625014 15.425543 403 5667 + 5670 O 14.311125 11.668895 8.886321 402 5671 5672 + 5671 H 13.349519 11.381714 8.877659 403 5670 + 5672 H 14.742001 11.037775 8.253125 403 5670 + 5673 O 21.499156 2.133932 3.402465 402 5674 5675 + 5674 H 22.423113 2.229631 3.696856 403 5673 + 5675 H 21.472059 1.349459 2.811378 403 5673 + 5676 O 22.466695 -14.225899 -2.830703 402 5677 5678 + 5677 H 22.948700 -13.678947 -2.237715 403 5676 + 5678 H 22.233121 -15.024736 -2.381007 403 5676 + 5679 O -17.714836 -8.402483 -11.856647 402 5680 5681 + 5680 H -18.457906 -8.997855 -11.616200 403 5679 + 5681 H -16.950883 -8.800780 -11.389594 403 5679 + 5682 O -13.154395 20.875531 -1.901594 402 5683 5684 + 5683 H -14.099007 20.684326 -1.676218 403 5682 + 5684 H -12.776951 21.273644 -1.137151 403 5682 + 5685 O 10.058528 -10.804893 -19.659672 402 5686 5687 + 5686 H 10.024212 -10.944820 -18.690131 403 5685 + 5687 H 9.262507 -10.364334 -19.857371 403 5685 + 5688 O 24.206149 -6.530273 6.651758 402 5689 5690 + 5689 H 23.298132 -6.779979 6.469418 403 5688 + 5690 H 24.435964 -6.280937 7.532499 403 5688 + 5691 O -0.769539 13.370711 18.754750 402 5692 5693 + 5692 H -1.399471 13.295369 18.002641 403 5691 + 5693 H -1.282846 13.503163 19.578024 403 5691 + 5694 O 12.489489 -16.824385 17.447916 402 5695 5696 + 5695 H 12.052693 -16.106503 17.961272 403 5694 + 5696 H 12.979700 -17.322750 18.119196 403 5694 + 5697 O 22.391449 -7.947848 18.889943 402 5698 5699 + 5698 H 22.777744 -7.558109 18.080179 403 5697 + 5699 H 21.582771 -8.396208 18.531967 403 5697 + 5700 O 24.444175 12.917036 5.832052 402 5701 5702 + 5701 H 24.511172 13.835523 6.045623 403 5700 + 5702 H 23.797849 12.920835 5.128292 403 5700 + 5703 O 13.404469 11.238393 -13.308046 402 5704 5705 + 5704 H 13.712479 10.420163 -13.763288 403 5703 + 5705 H 12.688252 10.856036 -12.768343 403 5703 + 5706 O 20.968072 -7.216860 -20.774585 402 5707 5708 + 5707 H 21.500932 -6.797898 -20.085206 403 5706 + 5708 H 21.506305 -7.089210 -21.583804 403 5706 + 5709 O -17.856365 -7.389334 -15.755928 402 5710 5711 + 5710 H -17.779099 -7.695814 -16.681187 403 5709 + 5711 H -17.454778 -6.543622 -15.646073 403 5709 + 5712 O -5.627767 -14.791821 -18.435422 402 5713 5714 + 5713 H -6.515410 -14.559760 -18.598093 403 5712 + 5714 H -5.318446 -15.164242 -19.264852 403 5712 + 5715 O 2.656405 -0.176950 -14.262302 402 5716 5717 + 5716 H 2.534896 -0.323212 -15.231477 403 5715 + 5717 H 3.447328 0.360291 -14.052654 403 5715 + 5718 O -26.736151 5.658653 0.855763 402 5719 5720 + 5719 H -25.877403 5.925247 0.635025 403 5718 + 5720 H -26.753355 4.689074 0.832778 403 5718 + 5721 O -8.652434 19.947608 -11.265190 402 5722 5723 + 5722 H -8.042720 19.800388 -11.992106 403 5721 + 5723 H -8.377500 20.767189 -10.778181 403 5721 + 5724 O 3.645772 -16.139913 -20.354692 402 5725 5726 + 5725 H 3.723824 -17.050742 -20.075710 403 5724 + 5726 H 3.139128 -16.051183 -21.192748 403 5724 + 5727 O 2.751218 19.096756 -12.278055 402 5728 5729 + 5728 H 3.589100 18.687062 -12.053483 403 5727 + 5729 H 2.907368 19.432717 -13.149786 403 5727 + 5730 O 11.895340 -6.132227 -17.645418 402 5731 5732 + 5731 H 12.272195 -6.990163 -17.614612 403 5730 + 5732 H 12.522919 -5.533948 -18.055179 403 5730 + 5733 O -2.649062 -11.532506 14.303842 402 5734 5735 + 5734 H -2.171418 -10.788172 14.727655 403 5733 + 5735 H -3.444108 -11.118837 14.016513 403 5733 + 5736 O 0.083662 -17.539610 -9.794080 402 5737 5738 + 5737 H 0.925887 -17.184555 -10.098352 403 5736 + 5738 H 0.064605 -17.230344 -8.891803 403 5736 + 5739 O -23.495878 -18.174487 -3.096140 402 5740 5741 + 5740 H -23.397765 -18.550076 -2.214521 403 5739 + 5741 H -23.991094 -18.883389 -3.445375 403 5739 + 5742 O -2.870665 -20.299637 3.495989 402 5743 5744 + 5743 H -2.025936 -20.316623 2.990845 403 5742 + 5744 H -2.887489 -19.480343 3.955086 403 5742 + 5745 O -23.237675 -7.968838 11.601659 402 5746 5747 + 5746 H -23.646989 -7.664067 12.406714 403 5745 + 5747 H -22.916603 -8.875240 11.799352 403 5745 + 5748 O 7.034857 17.671926 16.668461 402 5749 5750 + 5749 H 6.910916 17.021535 17.353714 403 5748 + 5750 H 7.298259 17.003434 15.931912 403 5748 + 5751 O -3.135847 -0.037211 -19.720235 402 5752 5753 + 5752 H -2.687204 -0.465713 -19.004635 403 5751 + 5753 H -3.883189 -0.596483 -19.830762 403 5751 + 5754 O -4.116282 9.933467 -15.972432 402 5755 5756 + 5755 H -4.382486 10.098448 -16.874934 403 5754 + 5756 H -3.276586 10.322141 -15.857331 403 5754 + 5757 O 9.001776 -2.037724 13.845066 402 5758 5759 + 5758 H 9.557925 -2.591779 14.385639 403 5757 + 5759 H 8.707709 -2.619965 13.087293 403 5757 + 5760 O -14.291358 -16.357375 0.136544 402 5761 5762 + 5761 H -14.623350 -16.546154 1.040530 403 5760 + 5762 H -13.337866 -16.185545 0.296606 403 5760 + 5763 O -8.307685 7.831957 -19.053875 402 5764 5765 + 5764 H -8.711204 7.493084 -18.235703 403 5763 + 5765 H -7.891044 8.658915 -18.717398 403 5763 + 5766 O 20.987462 12.906787 9.958048 402 5767 5768 + 5767 H 21.435148 12.305385 10.516693 403 5766 + 5768 H 21.330938 12.746483 9.110616 403 5766 + 5769 O 24.845310 0.514421 -13.306188 402 5770 5771 + 5770 H 24.715007 0.071792 -14.155230 403 5769 + 5771 H 25.044193 1.459969 -13.507156 403 5769 + 5772 O 9.940414 -19.224463 8.285169 402 5773 5774 + 5773 H 10.344194 -19.951358 7.833443 403 5772 + 5774 H 9.604359 -18.739761 7.480563 403 5772 + 5775 O -21.714063 9.254293 -18.084261 402 5776 5777 + 5776 H -21.666348 10.112348 -18.429358 403 5775 + 5777 H -20.881272 8.819770 -18.352190 403 5775 + 5778 O -7.191585 20.361392 -7.614111 402 5779 5780 + 5779 H -7.827974 20.909525 -8.157675 403 5778 + 5780 H -7.763622 19.592347 -7.497909 403 5778 + 5781 O 7.492921 13.497090 -0.820023 402 5782 5783 + 5782 H 7.499014 13.132441 -1.738485 403 5781 + 5783 H 8.327452 13.163732 -0.446731 403 5781 + 5784 O 9.961122 -18.299786 1.611143 402 5785 5786 + 5785 H 10.342232 -17.763270 0.893187 403 5784 + 5786 H 9.632169 -19.079234 1.161105 403 5784 + 5787 O 27.327916 14.167474 11.338410 402 5788 5789 + 5788 H 27.056501 14.797382 10.658423 403 5787 + 5789 H 26.973899 14.521349 12.195671 403 5787 + 5790 O 25.841592 -10.137073 17.886653 402 5791 5792 + 5791 H 26.549845 -10.744837 17.581594 403 5790 + 5792 H 26.136382 -9.297891 18.115726 403 5790 + 5793 O -26.484582 -7.570640 0.220618 402 5794 5795 + 5794 H -25.957551 -8.034324 0.885908 403 5793 + 5795 H -27.278989 -8.010770 0.092994 403 5793 + 5796 O -15.507886 -14.234567 -19.185887 402 5797 5798 + 5797 H -16.428047 -14.062315 -19.146906 403 5796 + 5798 H -15.141693 -13.449414 -19.706261 403 5796 + 5799 O 19.398920 -6.403154 -4.265132 402 5800 5801 + 5800 H 18.793855 -6.981438 -4.692992 403 5799 + 5801 H 20.078652 -7.004436 -3.840081 403 5799 + 5802 O -14.727762 -11.689529 10.739544 402 5803 5804 + 5803 H -15.118028 -11.677285 11.572442 403 5802 + 5804 H -15.363496 -11.211251 10.219303 403 5802 + 5805 O -10.164834 -13.429658 -5.821471 402 5806 5807 + 5806 H -10.898604 -13.964191 -5.277591 403 5805 + 5807 H -10.251403 -12.561784 -5.414595 403 5805 + 5808 O 17.930460 13.937399 -7.632026 402 5809 5810 + 5809 H 17.350338 14.712619 -7.873504 403 5808 + 5810 H 17.573194 13.449935 -6.914302 403 5808 + 5811 O 22.771963 11.789723 -15.991841 402 5812 5813 + 5812 H 22.407892 10.960756 -15.803516 403 5811 + 5813 H 23.728244 11.844157 -15.970852 403 5811 + 5814 O -27.022171 -9.935535 -1.551898 402 5815 5816 + 5815 H -26.648537 -9.163079 -1.958000 403 5814 + 5816 H -27.147733 -10.561946 -2.264608 403 5814 + 5817 O -25.271131 5.141749 -12.209736 402 5818 5819 + 5818 H -25.693109 5.472145 -11.442865 403 5817 + 5819 H -24.406635 4.695966 -11.908321 403 5817 + 5820 O 3.108121 -20.428019 2.767972 402 5821 5822 + 5821 H 2.883888 -19.516039 2.682074 403 5820 + 5822 H 2.524652 -20.911289 2.151071 403 5820 + 5823 O 13.645477 -11.248379 -2.168699 402 5824 5825 + 5824 H 14.495812 -10.982395 -1.919860 403 5823 + 5825 H 13.602764 -10.946321 -3.131943 403 5823 + 5826 O -15.802101 -18.826697 -13.646876 402 5827 5828 + 5827 H -15.629728 -18.718460 -14.634045 403 5826 + 5828 H -16.312937 -19.607220 -13.527508 403 5826 + 5829 O 16.994190 -18.162501 0.782551 402 5830 5831 + 5830 H 16.183512 -18.419341 1.225144 403 5829 + 5831 H 17.692383 -18.785460 1.112617 403 5829 + 5832 O 0.346250 -8.244458 13.026523 402 5833 5834 + 5833 H -0.056728 -8.794215 13.707605 403 5832 + 5834 H 0.196186 -7.378794 13.513605 403 5832 + 5835 O -5.876633 -1.250758 16.950150 402 5836 5837 + 5836 H -5.897139 -0.851532 16.048115 403 5835 + 5837 H -6.813697 -1.215101 17.207829 403 5835 + 5838 O -2.852852 -1.916845 15.179008 402 5839 5840 + 5839 H -3.068812 -1.830206 16.106831 403 5838 + 5840 H -3.640384 -2.245054 14.797756 403 5838 + 5841 O -25.940841 -4.816621 -4.070316 402 5842 5843 + 5842 H -25.207622 -5.264430 -3.620016 403 5841 + 5843 H -26.649933 -4.717697 -3.451686 403 5841 + 5844 O 4.874827 1.473886 -14.337797 402 5845 5846 + 5845 H 5.189548 1.046518 -15.146140 403 5844 + 5846 H 5.658759 1.677209 -13.804635 403 5844 + 5847 O -11.399492 -17.545168 -11.709535 402 5848 5849 + 5848 H -10.632696 -17.968067 -12.065761 403 5847 + 5849 H -11.990484 -18.281339 -11.463174 403 5847 + 5850 O -21.235393 3.531686 -18.981903 402 5851 5852 + 5851 H -20.811243 2.725219 -19.355158 403 5850 + 5852 H -21.330003 4.199180 -19.707403 403 5850 + 5853 O 19.884738 13.457886 -16.503712 402 5854 5855 + 5854 H 20.546443 14.081854 -16.252605 403 5853 + 5855 H 19.863325 12.725299 -15.889148 403 5853 + 5856 O -7.613490 -18.734979 -2.286157 402 5857 5858 + 5857 H -7.224353 -19.383742 -2.870642 403 5856 + 5858 H -7.258594 -17.884019 -2.571812 403 5856 + 5859 O 20.179247 18.669512 -9.520770 402 5860 5861 + 5860 H 19.745104 19.383705 -9.949059 403 5859 + 5861 H 21.106271 18.888549 -9.619590 403 5859 + 5862 O 0.469489 5.800556 -16.240608 402 5863 5864 + 5863 H 0.192512 6.630216 -16.696807 403 5862 + 5864 H 0.599388 6.155641 -15.380452 403 5862 + 5865 O 6.877961 19.550178 -9.988757 402 5866 5867 + 5866 H 6.368993 19.971864 -9.244013 403 5865 + 5867 H 6.518231 19.965222 -10.851986 403 5865 + 5868 O 6.720059 20.276251 -3.381777 402 5869 5870 + 5869 H 5.891426 20.783054 -3.333942 403 5868 + 5870 H 6.919774 20.067477 -2.473444 403 5868 + 5871 O 22.013148 -15.969229 12.266907 402 5872 5873 + 5872 H 21.416898 -16.484884 11.623216 403 5871 + 5873 H 22.857478 -16.358079 12.000305 403 5871 + 5874 O -15.694438 7.944675 2.647767 402 5875 5876 + 5875 H -15.370792 7.967212 3.559417 403 5874 + 5876 H -15.467715 7.066496 2.332465 403 5874 + 5877 O -25.016666 -19.872056 -7.507112 402 5878 5879 + 5878 H -24.041389 -19.998563 -7.476847 403 5877 + 5879 H -25.261819 -19.677629 -8.458935 403 5877 + 5880 O -17.404966 16.289559 0.378862 402 5881 5882 + 5881 H -17.816202 15.395796 0.469359 403 5880 + 5882 H -16.592061 16.078371 -0.128857 403 5880 + 5883 O 11.719854 13.896915 -20.007550 402 5884 5885 + 5884 H 11.762017 13.509054 -20.946443 403 5883 + 5885 H 11.730057 13.211150 -19.340581 403 5883 + 5886 O -21.635289 10.922735 -14.289364 402 5887 5888 + 5887 H -22.250180 11.585121 -14.648600 403 5886 + 5888 H -20.920683 10.786571 -14.961527 403 5886 + 5889 O -24.042065 -5.374879 10.098466 402 5890 5891 + 5890 H -23.939428 -5.512490 9.105496 403 5889 + 5891 H -23.970753 -6.321333 10.460122 403 5889 + 5892 O -9.411597 6.559490 -16.669992 402 5893 5894 + 5893 H -10.312323 6.551498 -16.403482 403 5892 + 5894 H -9.011995 5.640085 -16.634798 403 5892 + 5895 O 9.530893 -11.884062 12.046782 402 5896 5897 + 5896 H 9.879650 -11.398694 11.280896 403 5895 + 5897 H 9.261341 -11.231618 12.651989 403 5895 + 5898 O -1.911349 -16.933894 1.374617 402 5899 5900 + 5899 H -2.219904 -17.739022 1.023023 403 5898 + 5900 H -1.747381 -16.334388 0.676612 403 5898 + 5901 O 26.179381 -17.174136 0.502901 402 5902 5903 + 5902 H 25.703357 -17.150578 -0.364558 403 5901 + 5903 H 25.879759 -16.529513 1.122222 403 5901 + 5904 O 23.006008 2.418768 11.548952 402 5905 5906 + 5905 H 22.123244 2.196506 11.872833 403 5904 + 5906 H 22.916266 2.423276 10.570078 403 5904 + 5907 O -25.061378 12.895337 -10.920642 402 5908 5909 + 5908 H -24.236859 12.794849 -10.380539 403 5907 + 5909 H -24.844809 13.124176 -11.856801 403 5907 + 5910 O 24.065450 16.186345 -1.562209 402 5911 5912 + 5911 H 23.818077 16.816733 -0.921419 403 5910 + 5912 H 24.446065 16.798992 -2.179306 403 5910 + 5913 O 21.877525 -11.997066 12.743827 402 5914 5915 + 5914 H 21.110101 -12.307846 12.276099 403 5913 + 5915 H 21.795852 -11.028569 12.668947 403 5913 + 5916 O -9.770390 12.275988 6.625277 402 5917 5918 + 5917 H -9.540551 11.529014 6.118639 403 5916 + 5918 H -9.063347 12.943993 6.639152 403 5916 + 5919 O 7.590434 -16.518614 -3.885689 402 5920 5921 + 5920 H 8.245405 -16.780602 -4.602660 403 5919 + 5921 H 8.060783 -16.730529 -3.006396 403 5919 + 5922 O -8.819809 7.819937 16.686859 402 5923 5924 + 5923 H -8.459184 7.862962 15.781131 403 5922 + 5924 H -8.333215 7.208627 17.206742 403 5922 + 5925 O -0.018770 12.851916 7.726452 402 5926 5927 + 5926 H -0.018534 13.815629 7.654360 403 5925 + 5927 H -0.678950 12.568762 8.379340 403 5925 + 5928 O 26.935998 -2.260542 -4.734090 402 5929 5930 + 5929 H 27.692757 -2.309847 -5.350797 403 5928 + 5930 H 27.186636 -2.518573 -3.802021 403 5928 + 5931 O 27.034878 8.922183 -3.893061 402 5932 5933 + 5932 H 26.315953 9.520583 -3.776301 403 5931 + 5933 H 27.485194 9.316156 -4.684455 403 5931 + 5934 O 8.051349 7.651612 -11.998393 402 5935 5936 + 5935 H 8.628507 7.928025 -11.260450 403 5934 + 5936 H 7.748144 8.473350 -12.355271 403 5934 + 5937 O -27.116258 -14.053521 12.105107 402 5938 5939 + 5938 H -27.545532 -13.197780 12.384888 403 5937 + 5939 H -26.358772 -13.875946 11.579879 403 5937 + 5940 O 23.554783 -11.406323 -3.754207 402 5941 5942 + 5941 H 24.096179 -11.152033 -2.997418 403 5940 + 5942 H 23.941749 -11.074873 -4.532762 403 5940 + 5943 O -6.910654 -17.603975 17.334387 402 5944 5945 + 5944 H -7.702761 -17.167889 17.745512 403 5943 + 5945 H -6.836320 -17.171292 16.454588 403 5943 + 5946 O -16.492037 5.302939 -1.579501 402 5947 5948 + 5947 H -16.042514 4.646869 -2.112816 403 5946 + 5948 H -15.801804 6.017062 -1.587499 403 5946 + 5949 O -23.756350 3.926953 -8.179925 402 5950 5951 + 5950 H -23.195167 4.286584 -8.893370 403 5949 + 5951 H -23.460247 3.034235 -7.983373 403 5949 + 5952 O -13.747357 8.818643 -3.799589 402 5953 5954 + 5953 H -13.952688 8.414506 -2.934484 403 5952 + 5954 H -13.853214 9.757832 -3.600478 403 5952 + 5955 O -1.628128 -12.816264 -17.331527 402 5956 5957 + 5956 H -2.433523 -13.356344 -17.119883 403 5955 + 5957 H -2.044696 -11.950129 -17.560931 403 5955 + 5958 O -0.085635 15.544048 -1.201911 402 5959 5960 + 5959 H -0.000781 16.405004 -1.546695 403 5958 + 5960 H -0.971991 15.289121 -0.919162 403 5958 + 5961 O -8.590554 17.067218 -10.033341 402 5962 5963 + 5962 H -8.478641 17.979748 -10.381694 403 5961 + 5963 H -9.177179 16.660222 -10.710438 403 5961 + 5964 O -18.092032 -16.862277 -18.860686 402 5965 5966 + 5965 H -17.787112 -16.936281 -17.986509 403 5964 + 5966 H -18.687545 -17.567560 -19.061403 403 5964 + 5967 O 11.369215 4.413430 15.924887 402 5968 5969 + 5968 H 11.372520 3.624729 15.359827 403 5967 + 5969 H 11.705477 5.119414 15.321428 403 5967 + 5970 O 12.784492 7.071253 19.464041 402 5971 5972 + 5971 H 12.860418 6.279814 18.965525 403 5970 + 5972 H 12.277088 6.716268 20.219705 403 5970 + 5973 O 12.068135 -8.262908 17.552171 402 5974 5975 + 5974 H 11.944483 -7.791072 18.350772 403 5973 + 5975 H 12.525141 -9.091659 17.770424 403 5973 + 5976 O 10.241854 4.742923 2.559332 402 5977 5978 + 5977 H 9.423895 4.504759 2.987600 403 5976 + 5978 H 10.968724 4.120073 2.820528 403 5976 + 5979 O 4.587851 -5.032891 12.160556 402 5980 5981 + 5980 H 4.431505 -4.242508 12.621627 403 5979 + 5981 H 5.402359 -4.988575 11.647199 403 5979 + 5982 O -24.230874 -6.577818 -16.070853 402 5983 5984 + 5983 H -23.682020 -6.608606 -15.296098 403 5982 + 5984 H -25.097764 -7.040376 -15.909446 403 5982 + 5985 O 20.182613 7.158966 1.874949 402 5986 5987 + 5986 H 20.915498 6.541606 2.146531 403 5985 + 5987 H 20.710894 7.927513 1.477203 403 5985 + 5988 O 21.755390 6.896132 -12.917138 402 5989 5990 + 5989 H 22.076449 7.236600 -12.089303 403 5988 + 5990 H 22.525120 6.527089 -13.344666 403 5988 + 5991 O 6.877822 -4.771079 6.941634 402 5992 5993 + 5992 H 7.368474 -3.917167 6.794895 403 5991 + 5993 H 6.561555 -4.815923 7.876455 403 5991 + 5994 O -17.794941 18.359853 16.305117 402 5995 5996 + 5995 H -18.421394 18.650198 16.927781 403 5994 + 5996 H -17.650629 19.254815 15.811542 403 5994 + 5997 O -2.602624 -16.412046 -10.596632 402 5998 5999 + 5998 H -2.730413 -15.479270 -10.244360 403 5997 + 5999 H -1.636947 -16.665956 -10.610129 403 5997 + 6000 O 3.935143 -2.077202 16.379950 402 6001 6002 + 6001 H 3.116180 -2.074570 16.871393 403 6000 + 6002 H 4.258130 -3.011541 16.214763 403 6000 + 6003 O 26.054987 14.635245 18.309718 402 6004 6005 + 6004 H 27.012144 14.531484 18.422001 403 6003 + 6005 H 25.883129 15.612156 18.232382 403 6003 + 6006 O 22.186055 -2.285036 -18.276384 402 6007 6008 + 6007 H 22.575561 -1.490206 -18.592190 403 6006 + 6008 H 21.774977 -1.952262 -17.452519 403 6006 + 6009 O 5.982701 12.874655 -19.536076 402 6010 6011 + 6010 H 6.160786 13.198075 -20.428652 403 6009 + 6011 H 6.854019 12.668623 -19.180374 403 6009 + 6012 O -6.054158 -13.744402 -7.200732 402 6013 6014 + 6013 H -6.689102 -14.438760 -7.467162 403 6012 + 6014 H -5.241683 -14.218938 -7.253580 403 6012 + 6015 O 7.766648 -19.472206 -8.674412 402 6016 6017 + 6016 H 7.994143 -19.850740 -7.811770 403 6015 + 6017 H 7.159819 -20.051349 -9.144842 403 6015 + 6018 O -13.899693 -2.310609 11.719170 402 6019 6020 + 6019 H -14.293895 -1.540339 11.338780 403 6018 + 6020 H -13.136046 -1.840341 12.108102 403 6018 + 6021 O 26.880118 -3.988040 -2.564260 402 6022 6023 + 6022 H 27.141785 -3.912376 -1.619664 403 6021 + 6023 H 25.991507 -4.403119 -2.509330 403 6021 + 6024 O 16.831698 -0.370079 16.786168 402 6025 6026 + 6025 H 17.550555 0.178386 16.456695 403 6024 + 6026 H 17.096485 -0.465948 17.715552 403 6024 + 6027 O 19.019953 8.994801 17.672825 402 6028 6029 + 6028 H 18.825567 9.927341 17.839722 403 6027 + 6029 H 19.072225 8.455310 18.528449 403 6027 + 6030 O -23.890734 -17.531047 20.103131 402 6031 6032 + 6031 H -24.410048 -17.249588 20.880036 403 6030 + 6032 H -23.243461 -16.838233 19.952601 403 6030 + 6033 O 24.612082 6.311703 -14.314049 402 6034 6035 + 6034 H 24.685511 6.721117 -15.194578 403 6033 + 6035 H 24.456182 5.357259 -14.330432 403 6033 + 6036 O 11.630912 5.335794 8.212450 402 6037 6038 + 6037 H 10.744689 5.096999 8.355771 403 6036 + 6038 H 11.632399 6.142908 7.660144 403 6036 + 6039 O 16.482829 -7.676138 17.246704 402 6040 6041 + 6040 H 15.832973 -7.172968 16.764273 403 6039 + 6041 H 17.323015 -7.087522 17.068424 403 6039 + 6042 O -14.246850 -1.445493 8.521283 402 6043 6044 + 6043 H -14.965431 -1.234868 9.098827 403 6042 + 6044 H -14.565647 -2.243574 8.052945 403 6042 + 6045 O -12.243735 5.878745 14.287709 402 6046 6047 + 6046 H -12.931194 5.878071 14.927194 403 6045 + 6047 H -12.476832 5.118118 13.758795 403 6045 + 6048 O 14.365931 -20.845025 6.067181 402 6049 6050 + 6049 H 14.538057 -20.237448 6.808442 403 6048 + 6050 H 15.204917 -21.078698 5.761047 403 6048 + 6051 O 16.298718 -4.138023 18.121710 402 6052 6053 + 6052 H 15.424215 -3.680129 18.372722 403 6051 + 6053 H 16.684549 -4.205202 19.001012 403 6051 + 6054 O -14.198508 -14.194772 -14.794207 402 6055 6056 + 6055 H -13.444357 -14.590983 -14.343955 403 6054 + 6056 H -13.774495 -13.612371 -15.434882 403 6054 + 6057 O -10.030484 -15.925396 14.049869 402 6058 6059 + 6058 H -9.661016 -16.753356 13.643301 403 6057 + 6059 H -9.506338 -15.169357 13.752939 403 6057 + 6060 O 2.620657 -7.959507 -20.667278 402 6061 6062 + 6061 H 2.062110 -7.160386 -20.605865 403 6060 + 6062 H 2.138798 -8.553220 -21.271787 403 6060 + 6063 O 5.778060 4.436909 12.837835 402 6064 6065 + 6064 H 5.362329 3.721975 13.322111 403 6063 + 6065 H 5.808629 5.246373 13.380366 403 6063 + 6066 O 16.866472 5.920215 7.405820 402 6067 6068 + 6067 H 16.435352 5.086965 7.209575 403 6066 + 6068 H 16.163833 6.543037 7.470100 403 6066 + 6069 O 17.825944 -3.501642 -5.065436 402 6070 6071 + 6070 H 17.700510 -2.538825 -4.863235 403 6069 + 6071 H 18.532466 -3.602326 -5.702852 403 6069 + 6072 O -11.681593 20.597292 5.432499 402 6073 6074 + 6073 H -11.969564 21.510542 5.152859 403 6072 + 6074 H -12.562576 20.147115 5.430236 403 6072 + 6075 O 21.531845 -18.609965 -11.465553 402 6076 6077 + 6076 H 21.036885 -18.970566 -10.752405 403 6075 + 6077 H 20.911041 -18.252243 -12.167168 403 6075 + 6078 O 0.249866 -13.875504 -5.737561 402 6079 6080 + 6079 H 1.053242 -14.152812 -5.334020 403 6078 + 6080 H 0.540234 -13.078009 -6.238789 403 6078 + 6081 O 3.047539 17.051565 11.568254 402 6082 6083 + 6082 H 3.164343 17.306128 12.474589 403 6081 + 6083 H 2.524042 17.779795 11.213697 403 6081 + 6084 O 24.178795 -4.873391 -17.954897 402 6085 6086 + 6085 H 23.609912 -4.083965 -18.078992 403 6084 + 6086 H 24.401168 -4.923489 -16.992528 403 6084 + 6087 O 3.954939 20.513379 -14.418517 402 6088 6089 + 6088 H 3.581046 20.093104 -15.154897 403 6087 + 6089 H 3.811800 21.468596 -14.662255 403 6087 + 6090 O -0.149556 2.777227 -12.291758 402 6091 6092 + 6091 H -0.121223 2.435369 -11.351012 403 6090 + 6092 H 0.596183 3.441893 -12.318897 403 6090 + 6093 O 27.193112 8.418341 -10.172198 402 6094 6095 + 6094 H 26.787164 8.259494 -11.042944 403 6093 + 6095 H 27.410726 9.433106 -10.260356 403 6093 + 6096 O -24.022975 1.655208 -11.524687 402 6097 6098 + 6097 H -24.291048 0.824835 -11.888466 403 6096 + 6098 H -24.881489 1.940641 -11.171341 403 6096 + 6099 O 26.405280 -5.462847 -5.065504 402 6100 6101 + 6100 H 26.209462 -6.029181 -5.803215 403 6099 + 6101 H 27.373218 -5.317034 -5.077630 403 6099 + 6102 O -3.690721 10.045789 -20.208648 402 6103 6104 + 6103 H -4.248266 9.317998 -19.851069 403 6102 + 6104 H -2.834866 9.590938 -20.465215 403 6102 + 6105 O -2.559171 12.379195 -18.651596 402 6106 6107 + 6106 H -3.295406 13.039384 -18.601178 403 6105 + 6107 H -2.957289 11.575659 -18.948915 403 6105 + 6108 O 9.997514 -3.540058 20.611729 402 6109 6110 + 6109 H 9.428623 -3.673422 21.365363 403 6108 + 6110 H 10.919581 -3.718379 20.892643 403 6108 + 6111 O 22.711145 -8.644902 0.632604 402 6112 6113 + 6112 H 23.670226 -8.511619 0.628432 403 6111 + 6113 H 22.493868 -9.498519 0.275412 403 6111 + 6114 O 14.085903 -1.038370 -16.414394 402 6115 6116 + 6115 H 14.059869 -1.196217 -15.467296 403 6114 + 6116 H 13.262318 -1.459953 -16.715075 403 6114 + 6117 O -12.216643 15.094727 14.953780 402 6118 6119 + 6118 H -11.931679 15.769402 14.281719 403 6117 + 6119 H -13.149517 15.224147 15.123844 403 6117 + 6120 O -24.757277 7.231003 8.542276 402 6121 6122 + 6121 H -24.784189 8.210199 8.450823 403 6120 + 6122 H -24.549551 6.922193 9.397707 403 6120 + 6123 O 3.372929 19.847026 -0.606151 402 6124 6125 + 6124 H 3.191569 19.283633 -1.369340 403 6123 + 6125 H 4.347642 20.010416 -0.683022 403 6123 + 6126 O 8.872330 -16.761760 17.202410 402 6127 6128 + 6127 H 8.996558 -17.151460 16.293393 403 6126 + 6128 H 9.700285 -17.024144 17.621618 403 6126 + 6129 O 9.343569 14.953908 -19.877613 402 6130 6131 + 6130 H 9.005091 14.803515 -18.977870 403 6129 + 6131 H 10.168474 14.477496 -19.931351 403 6129 + 6132 O 2.034725 4.776928 20.854933 402 6133 6134 + 6133 H 2.700859 5.449702 20.919206 403 6132 + 6134 H 1.289075 5.153942 21.314556 403 6132 + 6135 O 18.285982 7.046313 3.854888 402 6136 6137 + 6136 H 18.754091 7.109170 3.047358 403 6135 + 6137 H 18.852898 6.489134 4.447893 403 6135 + 6138 O 17.000427 19.166068 19.844454 402 6139 6140 + 6139 H 17.780774 18.891038 19.347291 403 6138 + 6140 H 16.338665 18.528198 19.533743 403 6138 + 6141 O 4.309924 6.553220 -20.552969 402 6142 6143 + 6142 H 4.375422 6.917713 -21.455723 403 6141 + 6143 H 5.249758 6.290930 -20.364274 403 6141 + 6144 O 20.777753 -4.985339 -6.248152 402 6145 6146 + 6145 H 20.286399 -4.821264 -7.053768 403 6144 + 6146 H 20.234568 -5.537952 -5.671124 403 6144 + 6147 O 4.730675 15.020276 -10.674086 402 6148 6149 + 6148 H 4.376943 14.834207 -9.767214 403 6147 + 6149 H 4.726770 15.973286 -10.733237 403 6147 + 6150 O 2.355355 1.234033 17.572616 402 6151 6152 + 6151 H 3.034023 1.365267 16.849468 403 6150 + 6152 H 1.929729 2.103871 17.645246 403 6150 + 6153 O -20.364763 -10.341423 19.798444 402 6154 6155 + 6154 H -20.097141 -9.967826 18.943902 403 6153 + 6155 H -20.518570 -9.582890 20.375779 403 6153 + 6156 O 24.191317 -20.301143 13.503559 402 6157 6158 + 6157 H 25.075667 -20.080336 13.914227 403 6156 + 6158 H 23.551864 -19.853712 14.034970 403 6156 + 6159 O -17.771965 -0.812840 5.691659 402 6160 6161 + 6160 H -17.110001 -0.172585 5.922995 403 6159 + 6161 H -18.609271 -0.533119 5.998788 403 6159 + 6162 O 8.428411 7.992467 20.234546 402 6163 6164 + 6163 H 9.349683 8.062329 20.534745 403 6162 + 6164 H 7.930578 8.665863 20.632958 403 6162 + 6165 O 14.933965 18.875827 -5.159997 402 6166 6167 + 6166 H 14.094884 19.194527 -5.500018 403 6165 + 6167 H 15.603425 19.608364 -5.196749 403 6165 + 6168 O -11.010909 -1.265131 18.652423 402 6169 6170 + 6169 H -11.027649 -1.155636 17.705218 403 6168 + 6170 H -10.091875 -1.091225 18.938417 403 6168 + 6171 O -21.191413 -9.651017 -4.562795 402 6172 6173 + 6172 H -20.962638 -9.680538 -5.508642 403 6171 + 6173 H -20.795476 -10.416878 -4.182448 403 6171 + 6174 O 5.099725 -12.626597 -17.884817 402 6175 6176 + 6175 H 5.666927 -12.400935 -17.105607 403 6174 + 6176 H 4.764175 -11.785457 -18.184293 403 6174 + 6177 O -21.388510 -5.492100 10.971049 402 6178 6179 + 6178 H -22.216480 -5.626371 10.534286 403 6177 + 6179 H -21.551676 -5.367629 11.909886 403 6177 + 6180 O -26.689928 -8.293398 13.111418 402 6181 6182 + 6181 H -27.003954 -8.182450 12.219010 403 6180 + 6182 H -26.900928 -9.235390 13.263182 403 6180 + 6183 O 6.162303 19.062401 -17.622686 402 6184 6185 + 6184 H 5.955026 19.807434 -17.095725 403 6183 + 6185 H 6.287880 18.311383 -17.062421 403 6183 + 6186 O -26.568944 19.936247 1.863051 402 6187 6188 + 6187 H -26.429552 19.451776 1.050937 403 6186 + 6188 H -25.730651 20.069282 2.308590 403 6186 + 6189 O -12.939452 -17.938569 9.558916 402 6190 6191 + 6190 H -12.598970 -18.093496 10.439491 403 6189 + 6191 H -13.201371 -18.755858 9.152488 403 6189 + 6192 O -11.464685 7.314998 -14.468616 402 6193 6194 + 6193 H -12.254067 7.075040 -13.971198 403 6192 + 6194 H -11.784844 7.883355 -15.166065 403 6192 + 6195 O 20.495565 -8.915532 9.256247 402 6196 6197 + 6196 H 19.761356 -9.177749 9.963841 403 6195 + 6197 H 20.333767 -7.961456 9.244216 403 6195 + 6198 O -16.958223 -6.637117 15.942724 402 6199 6200 + 6199 H -17.590511 -6.925764 15.256778 403 6198 + 6200 H -17.006530 -7.309307 16.639627 403 6198 + 6201 O -7.465242 20.880802 3.955458 402 6202 6203 + 6202 H -6.906639 21.395406 3.368693 403 6201 + 6203 H -7.384772 21.435308 4.777200 403 6201 + 6204 O 10.987484 -10.220761 -0.486092 402 6205 6206 + 6205 H 11.657995 -10.039232 -1.157052 403 6204 + 6206 H 10.134305 -10.217278 -0.922065 403 6204 + 6207 O -11.745045 12.656305 2.561380 402 6208 6209 + 6208 H -12.067404 12.975187 3.387647 403 6207 + 6209 H -11.009457 12.085090 2.865904 403 6207 + 6210 O -5.579572 -16.497607 -20.750701 402 6211 6212 + 6211 H -4.847773 -16.621590 -21.371280 403 6210 + 6212 H -6.034567 -17.358476 -20.680344 403 6210 + 6213 O 1.964841 -7.772342 -15.446535 402 6214 6215 + 6214 H 2.789953 -8.261174 -15.222416 403 6213 + 6215 H 1.224980 -8.401255 -15.497885 403 6213 + 6216 O 17.133687 20.836195 -5.235713 402 6217 6218 + 6217 H 16.963395 21.728366 -4.832203 403 6216 + 6218 H 18.061664 20.710791 -5.306008 403 6216 + 6219 O -18.390780 10.973515 3.704388 402 6220 6221 + 6220 H -19.253132 11.409402 3.769882 403 6219 + 6221 H -18.035350 10.771168 4.577357 403 6219 + 6222 O 14.221292 20.673222 -19.936970 402 6223 6224 + 6223 H 13.920637 20.243897 -20.741067 403 6222 + 6224 H 14.685112 21.462779 -20.332088 403 6222 + 6225 O -21.084831 12.253935 9.565359 402 6226 6227 + 6226 H -20.600168 11.482007 9.886149 403 6225 + 6227 H -21.728096 12.542158 10.140605 403 6225 + 6228 O 21.807475 -0.416214 2.152466 402 6229 6230 + 6229 H 22.039987 -0.306167 1.206900 403 6228 + 6230 H 22.400722 -1.068057 2.516791 403 6228 + 6231 O 20.924050 10.441338 14.208356 402 6232 6233 + 6232 H 21.615541 10.869208 14.797933 403 6231 + 6233 H 20.771960 9.540413 14.573568 403 6231 + 6234 O 6.259921 4.454937 -17.265429 402 6235 6236 + 6235 H 6.706330 4.203652 -18.064753 403 6234 + 6236 H 5.711163 3.710753 -17.001578 403 6234 + 6237 O -4.214022 14.596706 -18.431597 402 6238 6239 + 6238 H -3.688756 15.025866 -17.718188 403 6237 + 6239 H -5.088033 14.473133 -18.084790 403 6237 + 6240 O -2.199419 13.906578 9.672426 402 6241 6242 + 6241 H -2.129396 13.038932 9.992785 403 6240 + 6242 H -3.120153 14.058476 9.477073 403 6240 + 6243 O 9.044748 2.046702 -11.991573 402 6244 6245 + 6244 H 9.465655 2.820071 -11.709794 403 6243 + 6245 H 8.080161 2.265383 -12.092250 403 6243 + 6246 O 7.143894 -11.920235 -15.669336 402 6247 6248 + 6247 H 6.531119 -11.505986 -15.060545 403 6246 + 6248 H 7.414267 -12.765754 -15.195832 403 6246 + 6249 O -5.826228 -0.168688 14.337506 402 6250 6251 + 6250 H -5.465882 -0.527232 13.513436 403 6249 + 6251 H -5.608854 0.802946 14.323569 403 6249 + 6252 O 5.648885 3.826675 19.190577 402 6253 6254 + 6253 H 5.186784 3.361795 19.925791 403 6252 + 6254 H 5.056212 3.823989 18.450900 403 6252 + 6255 O 9.326815 -6.082614 -17.012500 402 6256 6257 + 6256 H 10.201835 -6.094812 -17.433769 403 6255 + 6257 H 9.461714 -5.493002 -16.251384 403 6255 + 6258 O -1.961522 -12.154184 11.549933 402 6259 6260 + 6259 H -1.624684 -11.469274 10.968619 403 6258 + 6260 H -2.192863 -11.701664 12.378278 403 6258 + 6261 O 22.610380 9.966271 5.674665 402 6262 6263 + 6262 H 23.383558 10.326639 6.158091 403 6261 + 6263 H 22.639822 10.376867 4.833334 403 6261 + 6264 O -15.460748 19.613439 2.679694 402 6265 6266 + 6265 H -16.411896 19.506793 2.586178 403 6264 + 6266 H -14.953260 19.393944 1.878689 403 6264 + 6267 O -9.915773 -6.329847 7.803991 402 6268 6269 + 6268 H -9.882720 -5.651785 8.461110 403 6267 + 6269 H -10.460430 -6.991760 8.214687 403 6267 + 6270 O -25.207118 14.245870 9.965310 402 6271 6272 + 6271 H -24.983683 14.155643 9.024696 403 6270 + 6272 H -26.142233 13.940881 10.004034 403 6270 + 6273 O -25.736790 -11.761067 -20.022820 402 6274 6275 + 6274 H -25.863929 -11.074881 -20.678750 403 6273 + 6275 H -24.932339 -12.237137 -20.159436 403 6273 + 6276 O 11.102836 18.814945 6.564463 402 6277 6278 + 6277 H 11.289797 19.730591 6.307298 403 6276 + 6278 H 11.992226 18.441595 6.571960 403 6276 + 6279 O 13.403000 -2.765436 13.474813 402 6280 6281 + 6280 H 13.769730 -2.059344 13.993878 403 6279 + 6281 H 12.629241 -3.051764 13.938568 403 6279 + 6282 O -4.846771 12.989332 0.138872 402 6283 6284 + 6283 H -5.140341 12.692091 -0.669471 403 6282 + 6284 H -4.237694 12.323085 0.503203 403 6282 + 6285 O -7.158804 -10.565376 -14.125410 402 6286 6287 + 6286 H -7.106658 -9.969989 -13.387772 403 6285 + 6287 H -8.014522 -10.262139 -14.505555 403 6285 + 6288 O -27.281285 1.637807 7.500082 402 6289 6290 + 6289 H -28.034365 1.595491 8.055974 403 6288 + 6290 H -27.473389 0.963037 6.821339 403 6288 + 6291 O -0.097834 20.799965 16.033059 402 6292 6293 + 6292 H -0.061833 20.955427 16.971561 403 6291 + 6293 H 0.211633 19.849506 15.947964 403 6291 + 6294 O -17.560941 -8.904350 -7.470152 402 6295 6296 + 6295 H -17.692194 -9.827361 -7.296744 403 6294 + 6296 H -18.413628 -8.634527 -7.892701 403 6294 + 6297 O 19.510410 -2.135779 6.750602 402 6298 6299 + 6298 H 19.129310 -2.691827 6.012246 403 6297 + 6299 H 19.916248 -2.816246 7.354253 403 6297 + 6300 O -22.550074 2.726993 8.069055 402 6301 6302 + 6301 H -22.055287 3.149406 8.816420 403 6300 + 6302 H -23.436863 2.498421 8.376578 403 6300 + 6303 O 12.975725 16.091516 4.066177 402 6304 6305 + 6304 H 12.574447 15.652668 4.834328 403 6303 + 6305 H 13.351330 15.347325 3.556206 403 6303 + 6306 O 4.646769 -11.986650 5.429828 402 6307 6308 + 6307 H 4.999571 -11.714192 4.521067 403 6306 + 6308 H 3.860805 -12.541717 5.180051 403 6306 + 6309 O -25.235875 -9.797804 -17.843826 402 6310 6311 + 6310 H -24.333006 -9.678887 -17.478651 403 6309 + 6311 H -25.154219 -10.357082 -18.609102 403 6309 + 6312 O 11.868872 -11.212949 -8.438903 402 6313 6314 + 6313 H 11.896093 -12.062241 -7.862109 403 6312 + 6314 H 12.728803 -11.139741 -8.855401 403 6312 + 6315 O 17.367617 -1.497743 -14.604934 402 6316 6317 + 6316 H 17.309530 -0.538237 -14.454327 403 6315 + 6317 H 16.651273 -1.922704 -14.219436 403 6315 + 6318 O 8.667339 4.899012 8.930629 402 6319 6320 + 6319 H 8.353473 5.408040 8.182722 403 6318 + 6320 H 8.163336 5.229248 9.676915 403 6318 + 6321 O -15.429574 17.683315 9.572006 402 6322 6323 + 6322 H -15.724205 17.604776 10.464011 403 6321 + 6323 H -15.265015 16.716829 9.310192 403 6321 + 6324 O -23.494483 -11.734522 -13.358407 402 6325 6326 + 6325 H -22.637486 -11.515244 -13.732205 403 6324 + 6326 H -23.249990 -12.537148 -12.866248 403 6324 + 6327 O -2.321548 19.267216 -1.843679 402 6328 6329 + 6328 H -1.979401 18.732155 -2.589027 403 6327 + 6329 H -1.922284 20.138548 -2.014462 403 6327 + 6330 O 3.241639 7.816664 9.859978 402 6331 6332 + 6331 H 3.830186 8.534324 10.230363 403 6330 + 6332 H 3.848530 7.292787 9.307399 403 6330 + 6333 O 23.128975 -6.691964 -6.315464 402 6334 6335 + 6334 H 23.778438 -6.570891 -6.974137 403 6333 + 6335 H 22.501465 -5.970161 -6.490266 403 6333 + 6336 O 19.510034 14.065263 20.822119 402 6337 6338 + 6337 H 19.858660 14.498532 21.601080 403 6336 + 6338 H 18.527411 14.085196 20.963708 403 6336 + 6339 O 23.620502 15.862352 -17.889270 402 6340 6341 + 6340 H 23.702347 16.808368 -17.871251 403 6339 + 6341 H 24.460420 15.474942 -18.227702 403 6339 + 6342 O 0.280487 -11.413982 6.100970 402 6343 6344 + 6343 H -0.020983 -11.734838 5.286550 403 6342 + 6344 H -0.533188 -11.093828 6.515383 403 6342 + 6345 O 4.888182 13.212978 -12.788937 402 6346 6347 + 6346 H 4.811212 13.849406 -12.115682 403 6345 + 6347 H 5.658749 13.451904 -13.292659 403 6345 + 6348 O -0.778683 -14.633842 19.192088 402 6349 6350 + 6349 H 0.068746 -14.541913 19.608269 403 6348 + 6350 H -0.746217 -14.102331 18.428497 403 6348 + 6351 O 13.914707 -6.162346 9.195387 402 6352 6353 + 6352 H 13.649776 -6.881207 8.533412 403 6351 + 6353 H 13.921705 -5.396594 8.630327 403 6351 + 6354 O 5.918950 -10.003796 18.819888 402 6355 6356 + 6355 H 5.593681 -9.082358 18.773797 403 6354 + 6356 H 6.335696 -10.082856 17.966116 403 6354 + 6357 O 5.800793 -13.047074 9.485819 402 6358 6359 + 6358 H 5.149198 -12.578404 10.015587 403 6357 + 6359 H 5.268076 -13.674415 8.965513 403 6357 + 6360 O -14.871416 6.062880 9.725201 402 6361 6362 + 6361 H -14.929573 6.618371 8.917863 403 6360 + 6362 H -14.144906 5.419527 9.466087 403 6360 + 6363 O 20.324875 13.466462 -0.499122 402 6364 6365 + 6364 H 21.247971 13.704707 -0.183814 403 6363 + 6365 H 20.407782 13.624960 -1.484430 403 6363 + 6366 O 14.435517 -20.166926 -14.557910 402 6367 6368 + 6367 H 15.392894 -20.186163 -14.367445 403 6366 + 6368 H 14.408577 -20.346774 -15.497151 403 6366 + 6369 O -16.234833 1.803853 -11.857132 402 6370 6371 + 6370 H -16.542525 1.963315 -10.988159 403 6369 + 6371 H -16.125965 2.663685 -12.253266 403 6369 + 6372 O 5.603802 10.853652 14.181232 402 6373 6374 + 6373 H 4.967001 11.570744 14.103506 403 6372 + 6374 H 5.112428 10.099067 14.600012 403 6372 + 6375 O -9.571538 -5.196535 -13.987191 402 6376 6377 + 6376 H -8.921300 -5.201306 -13.287766 403 6375 + 6377 H -9.272779 -4.631556 -14.762861 403 6375 + 6378 O -0.910109 -6.872259 20.397408 402 6379 6380 + 6379 H -1.142400 -7.798393 20.536047 403 6378 + 6380 H -1.036778 -6.702293 19.444051 403 6378 + 6381 O -12.922858 14.220990 -13.435094 402 6382 6383 + 6382 H -13.045814 13.904342 -12.512925 403 6381 + 6383 H -11.991363 14.443415 -13.600018 403 6381 + 6384 O -20.145038 7.688023 -15.204652 402 6385 6386 + 6385 H -19.285409 7.391425 -14.875634 403 6384 + 6386 H -20.496640 7.059764 -15.839841 403 6384 + 6387 O -5.329489 -11.195881 -18.058590 402 6388 6389 + 6388 H -4.529646 -10.716556 -18.053482 403 6387 + 6389 H -5.175370 -11.944129 -17.502821 403 6387 + 6390 O -4.095176 7.801479 14.167088 402 6391 6392 + 6391 H -4.165281 6.967753 13.710500 403 6390 + 6392 H -4.424466 8.518942 13.657209 403 6390 + 6393 O 4.268934 -2.427400 -14.058821 402 6394 6395 + 6394 H 3.658313 -1.685938 -14.058738 403 6393 + 6395 H 4.003282 -2.951965 -14.808726 403 6393 + 6396 O 8.751768 -9.075907 8.222826 402 6397 6398 + 6397 H 8.238298 -9.781595 7.726938 403 6396 + 6398 H 8.832788 -8.372787 7.566934 403 6396 + 6399 O -2.030633 -16.421805 9.382972 402 6400 6401 + 6400 H -3.001825 -16.480774 9.651189 403 6399 + 6401 H -1.831960 -15.434055 9.498271 403 6399 + 6402 O -25.423917 -5.184358 19.460275 402 6403 6404 + 6403 H -25.411355 -4.513854 18.790648 403 6402 + 6404 H -24.533549 -5.279059 19.872583 403 6402 + 6405 O -2.666399 -5.808727 -16.793146 402 6406 6407 + 6406 H -2.024398 -6.172832 -16.200012 403 6405 + 6407 H -3.330516 -5.483909 -16.238573 403 6405 + 6408 O 21.181989 15.710253 -10.722839 402 6409 6410 + 6409 H 20.653330 16.200547 -11.388544 403 6408 + 6410 H 20.518018 15.224350 -10.216895 403 6408 + 6411 O 10.656923 -19.476259 -2.456922 402 6412 6413 + 6412 H 10.832717 -19.488093 -3.445481 403 6411 + 6413 H 10.250558 -20.351142 -2.291869 403 6411 + 6414 O 25.111320 11.672906 -19.193595 402 6415 6416 + 6415 H 25.138171 11.478665 -18.282125 403 6414 + 6416 H 24.182357 11.511761 -19.351363 403 6414 + 6417 O -23.200367 10.470264 2.902172 402 6418 6419 + 6418 H -22.375402 10.749923 3.283481 403 6417 + 6419 H -23.150590 10.446395 1.924180 403 6417 + 6420 O -2.505105 -5.473938 -19.743686 402 6421 6422 + 6421 H -1.843966 -5.849443 -20.362634 403 6420 + 6422 H -2.920619 -6.270770 -19.289080 403 6420 + 6423 O -8.780745 -1.877077 -14.922296 402 6424 6425 + 6424 H -8.514938 -2.635843 -15.397360 403 6423 + 6425 H -9.085199 -1.200825 -15.532893 403 6423 + 6426 O 24.088505 -5.188189 -2.808937 402 6427 6428 + 6427 H 23.599921 -6.002172 -2.943267 403 6426 + 6428 H 23.455922 -4.686553 -2.320873 403 6426 + 6429 O 22.351359 7.425470 -10.093129 402 6430 6431 + 6430 H 22.221254 8.332765 -9.845260 403 6429 + 6431 H 21.646534 6.920728 -9.570168 403 6429 + 6432 O 14.350169 18.359669 4.097284 402 6433 6434 + 6433 H 14.109937 17.421914 3.931070 403 6432 + 6434 H 14.072554 18.536427 5.036536 403 6432 + 6435 O 27.317468 -3.450042 0.124188 402 6436 6437 + 6436 H 26.939527 -2.629423 0.463932 403 6435 + 6437 H 28.260772 -3.496973 0.454380 403 6435 + 6438 O 18.669483 0.162292 12.223874 402 6439 6440 + 6439 H 17.730334 0.262878 12.571330 403 6438 + 6440 H 18.943346 -0.589794 12.749858 403 6438 + 6441 O -5.566955 -16.930775 -16.571789 402 6442 6443 + 6442 H -6.441648 -17.209772 -16.309110 403 6441 + 6443 H -5.639154 -16.106816 -17.074766 403 6441 + 6444 O -2.921475 20.285760 15.744633 402 6445 6446 + 6445 H -2.016920 20.514916 15.782961 403 6444 + 6446 H -3.245126 20.259651 16.667577 403 6444 + 6447 O -5.332369 15.647169 -3.415792 402 6448 6449 + 6448 H -5.780073 16.016536 -4.186943 403 6447 + 6449 H -5.479798 16.195769 -2.646722 403 6447 + 6450 O 15.921074 -18.186514 13.419302 402 6451 6452 + 6451 H 16.506049 -18.207521 14.214727 403 6450 + 6452 H 15.521744 -17.337545 13.281325 403 6450 + 6453 O 14.356618 -12.746498 14.307435 402 6454 6455 + 6454 H 14.126271 -12.290732 13.456316 403 6453 + 6455 H 14.125424 -12.072615 14.973510 403 6453 + 6456 O -24.563586 19.861169 16.888289 402 6457 6458 + 6457 H -24.271423 19.518156 17.745286 403 6456 + 6458 H -25.132062 20.568890 17.055680 403 6456 + 6459 O 21.313706 -20.874831 -18.789259 402 6460 6461 + 6460 H 22.217533 -20.760960 -18.415032 403 6459 + 6461 H 20.727813 -20.829114 -18.018243 403 6459 + 6462 O -22.635680 0.425745 -16.655779 402 6463 6464 + 6463 H -22.761860 0.339162 -17.612196 403 6462 + 6464 H -23.459506 0.792307 -16.373813 403 6462 + 6465 O 26.144043 -9.495490 -14.387597 402 6466 6467 + 6466 H 25.579221 -8.746398 -14.601070 403 6465 + 6467 H 25.873666 -10.165392 -15.002042 403 6465 + 6468 O -23.297595 -18.906211 -0.461159 402 6469 6470 + 6469 H -22.408325 -19.188074 -0.167323 403 6468 + 6470 H -23.911286 -19.189688 0.234806 403 6468 + 6471 O -0.622548 17.838288 10.712907 402 6472 6473 + 6472 H -1.439971 18.247686 10.442799 403 6471 + 6473 H -0.378140 17.187351 10.096413 403 6471 + 6474 O 15.411072 -13.353252 8.623995 402 6475 6476 + 6475 H 14.707363 -12.901715 8.076042 403 6474 + 6476 H 15.905287 -13.988830 8.076423 403 6474 + 6477 O 21.923001 -19.583331 -14.240322 402 6478 6479 + 6478 H 22.075731 -18.649005 -14.150919 403 6477 + 6479 H 22.015325 -19.897017 -13.337089 403 6477 + 6480 O 2.935997 17.036657 8.133011 402 6481 6482 + 6481 H 3.807044 17.141662 7.698882 403 6480 + 6482 H 2.908723 17.824640 8.654298 403 6480 + 6483 O -27.412013 18.278336 3.981062 402 6484 6485 + 6484 H -28.006219 18.986550 3.874615 403 6483 + 6485 H -26.604657 18.625220 3.564949 403 6483 + 6486 O 24.767119 -17.376689 8.467100 402 6487 6488 + 6487 H 25.034677 -18.274073 8.247745 403 6486 + 6488 H 24.572504 -17.372764 9.407309 403 6486 + 6489 O -13.003243 -11.441578 13.780080 402 6490 6491 + 6490 H -12.042782 -11.458495 13.652747 403 6489 + 6491 H -13.148063 -12.394708 13.704955 403 6489 + 6492 O 15.688282 -7.232516 -0.339939 402 6493 6494 + 6493 H 16.449877 -6.627843 -0.361901 403 6492 + 6494 H 14.991365 -6.661690 -0.041038 403 6492 + 6495 O 11.147257 19.763552 -1.319428 402 6496 6497 + 6496 H 12.091516 19.826512 -1.542128 403 6495 + 6497 H 10.791166 18.908813 -1.667004 403 6495 + 6498 O -7.494481 -7.378915 14.293630 402 6499 6500 + 6499 H -8.055772 -6.598314 14.231678 403 6498 + 6500 H -7.492239 -7.996336 13.497808 403 6498 + 6501 O 12.398150 -14.923360 -13.423871 402 6502 6503 + 6502 H 13.226011 -15.063936 -12.905542 403 6501 + 6503 H 12.384263 -15.811229 -13.930308 403 6501 + 6504 O -27.354781 16.207013 -2.080282 402 6505 6506 + 6505 H -27.773374 15.417476 -1.753252 403 6504 + 6506 H -26.769089 15.853853 -2.726016 403 6504 + 6507 O -21.588756 -10.691290 -14.634202 402 6508 6509 + 6508 H -20.864974 -10.142417 -14.313329 403 6507 + 6509 H -22.092217 -10.206931 -15.343402 403 6507 + 6510 O -15.891662 -2.331448 -9.986612 402 6511 6512 + 6511 H -16.165526 -2.271915 -10.920230 403 6510 + 6512 H -16.438270 -1.699757 -9.489314 403 6510 + 6513 O 22.887456 16.566156 19.955577 402 6514 6515 + 6514 H 23.271415 15.746747 20.347130 403 6513 + 6515 H 22.072508 16.181382 19.562781 403 6513 + 6516 O 23.972546 -20.036642 10.589623 402 6517 6518 + 6517 H 22.980691 -20.033626 10.504814 403 6516 + 6518 H 24.188289 -20.743981 11.184377 403 6516 + 6519 O -14.810897 -16.471565 2.793852 402 6520 6521 + 6520 H -14.868506 -16.959673 3.603780 403 6519 + 6521 H -15.147942 -15.567810 2.891865 403 6519 + 6522 O 15.022183 19.763656 9.414504 402 6523 6524 + 6523 H 14.727721 20.725814 9.294400 403 6522 + 6524 H 14.198126 19.316744 9.803487 403 6522 + 6525 O 7.167340 -17.033861 0.122492 402 6526 6527 + 6526 H 7.922624 -17.174527 -0.428152 403 6525 + 6527 H 7.373246 -16.583291 0.937782 403 6525 + 6528 O -11.594968 10.896089 -10.580500 402 6529 6530 + 6529 H -11.121081 11.033261 -11.432170 403 6528 + 6530 H -10.865005 11.002637 -9.903313 403 6528 + 6531 O 13.844708 19.069913 -14.047834 402 6532 6533 + 6532 H 12.983337 18.716343 -13.811534 403 6531 + 6533 H 13.787413 20.053839 -14.066463 403 6531 + 6534 O 3.487281 19.589235 9.612730 402 6535 6536 + 6535 H 2.698355 20.090461 9.969632 403 6534 + 6536 H 4.250101 19.910242 10.053781 403 6534 + 6537 O -3.973097 19.421213 7.719503 402 6538 6539 + 6538 H -4.241991 20.257528 7.213642 403 6537 + 6539 H -3.132076 19.220373 7.212628 403 6537 + 6540 O -12.775076 2.609100 10.411237 402 6541 6542 + 6541 H -11.827718 2.459042 10.644395 403 6540 + 6542 H -12.804655 2.331119 9.464699 403 6540 + 6543 O -24.197168 6.439006 -6.711367 402 6544 6545 + 6544 H -25.160507 6.393035 -6.538446 403 6543 + 6545 H -23.942233 5.506445 -6.828627 403 6543 + 6546 O -2.117774 -4.949968 18.594717 402 6547 6548 + 6547 H -2.924336 -5.465197 18.506055 403 6546 + 6548 H -2.296534 -4.057750 18.222583 403 6546 + 6549 O -10.788206 6.295992 1.048829 402 6550 6551 + 6550 H -10.485607 7.066710 1.589289 403 6549 + 6551 H -10.038032 6.105261 0.487985 403 6549 + 6552 O -12.857377 -3.305264 -10.725085 402 6553 6554 + 6553 H -13.206640 -2.923560 -11.499351 403 6552 + 6554 H -13.499606 -3.077602 -10.047332 403 6552 + 6555 O -11.268130 12.801261 9.055194 402 6556 6557 + 6556 H -11.672865 13.689974 8.877182 403 6555 + 6557 H -11.032167 12.415049 8.150138 403 6555 + 6558 O 13.406197 0.438838 6.515611 402 6559 6560 + 6559 H 12.971912 1.148987 7.055731 403 6558 + 6560 H 13.378188 0.782754 5.596959 403 6558 + 6561 O 16.121687 13.290724 10.280494 402 6562 6563 + 6562 H 16.894647 12.756757 10.507582 403 6561 + 6563 H 15.529920 12.609242 9.885455 403 6561 + 6564 O 1.591126 8.482167 4.697447 402 6565 6566 + 6565 H 1.970540 9.119397 4.113006 403 6564 + 6566 H 2.267655 8.435325 5.388951 403 6564 + 6567 O -17.696505 1.721021 10.517174 402 6568 6569 + 6568 H -17.885845 2.645526 10.594973 403 6567 + 6569 H -18.179500 1.418546 11.298333 403 6567 + 6570 O -1.148874 9.889607 17.693251 402 6571 6572 + 6571 H -0.454725 10.039896 17.084647 403 6570 + 6572 H -1.617929 9.083378 17.328962 403 6570 + 6573 O -9.511269 -11.292655 15.803762 402 6574 6575 + 6574 H -10.218255 -10.722353 16.196307 403 6573 + 6575 H -9.799298 -12.212118 15.932439 403 6573 + 6576 O -15.065889 16.639418 -8.067448 402 6577 6578 + 6577 H -15.835102 17.201609 -8.362394 403 6576 + 6578 H -15.172025 15.753046 -8.516586 403 6576 + 6579 O -22.136814 -17.146244 -13.973167 402 6580 6581 + 6580 H -21.367059 -16.850746 -13.432779 403 6579 + 6581 H -22.384487 -16.427789 -14.634859 403 6579 + 6582 O 7.866282 -10.293632 -17.800934 402 6583 6584 + 6583 H 7.775951 -11.047150 -17.161148 403 6582 + 6584 H 8.173086 -9.555520 -17.163954 403 6582 + 6585 O -11.457596 -0.574420 15.816493 402 6586 6587 + 6586 H -11.795621 0.320073 15.789591 403 6585 + 6587 H -10.561019 -0.510839 15.442995 403 6585 + 6588 O 20.020980 -12.359468 -8.719780 402 6589 6590 + 6589 H 20.891102 -12.503083 -8.310836 403 6588 + 6590 H 19.657638 -11.746384 -8.095286 403 6588 + 6591 O -11.584374 -20.453145 18.626549 402 6592 6593 + 6592 H -11.940173 -20.540398 19.531255 403 6591 + 6593 H -12.005638 -21.078955 18.029825 403 6591 + 6594 O 3.431174 19.121516 18.407979 402 6595 6596 + 6595 H 3.226206 20.056373 18.426687 403 6594 + 6596 H 2.600881 18.679871 18.370259 403 6594 + 6597 O -13.315767 -3.798762 16.329856 402 6598 6599 + 6598 H -13.096103 -4.569637 15.670760 403 6597 + 6599 H -12.649730 -3.801668 17.013121 403 6597 + 6600 O 7.563392 -5.518546 10.504795 402 6601 6602 + 6601 H 6.706770 -5.750354 10.096728 403 6600 + 6602 H 7.922512 -6.417021 10.555834 403 6600 + 6603 O -18.725820 19.110329 -7.091283 402 6604 6605 + 6604 H -19.518142 19.318716 -7.662306 403 6603 + 6605 H -18.568680 19.881279 -6.590714 403 6603 + 6606 O -1.414023 -16.961715 12.639857 402 6607 6608 + 6607 H -1.328118 -15.968577 12.668980 403 6606 + 6608 H -1.076983 -17.347672 11.778245 403 6606 + 6609 O -23.307644 10.461811 -20.820802 402 6610 6611 + 6610 H -23.561946 9.673912 -20.318452 403 6609 + 6611 H -24.099105 10.583838 -21.379713 403 6609 + 6612 O 18.109258 -13.123924 17.182346 402 6613 6614 + 6613 H 19.074027 -13.199454 16.973877 403 6612 + 6614 H 17.765173 -12.302968 16.728002 403 6612 + 6615 O 21.683386 18.223931 -5.030005 402 6616 6617 + 6616 H 22.567099 18.027021 -5.437892 403 6615 + 6617 H 21.636745 17.754335 -4.163593 403 6615 + 6618 O 25.055072 19.034839 -7.681292 402 6619 6620 + 6619 H 24.766294 18.344263 -7.038060 403 6618 + 6620 H 25.882695 18.757787 -7.948244 403 6618 + 6621 O 15.570913 13.019010 5.553904 402 6622 6623 + 6622 H 15.992685 13.329314 6.362922 403 6621 + 6623 H 15.449140 12.068146 5.738277 403 6621 + 6624 O -0.520016 -0.269780 14.795928 402 6625 6626 + 6625 H -0.180326 -0.456884 15.694661 403 6624 + 6626 H -1.219092 -0.915185 14.727056 403 6624 + 6627 O 1.663902 -15.429144 -10.527250 402 6628 6629 + 6628 H 2.554915 -15.533567 -10.136462 403 6627 + 6629 H 1.815948 -15.297258 -11.416174 403 6627 + 6630 O -22.648336 -4.623238 -12.225694 402 6631 6632 + 6631 H -23.412412 -4.010770 -12.025660 403 6630 + 6632 H -21.872894 -4.224451 -11.815463 403 6630 + 6633 O -2.279585 -20.867759 -19.023308 402 6634 6635 + 6634 H -3.100549 -20.369345 -19.314139 403 6633 + 6635 H -1.811469 -21.235753 -19.767859 403 6633 + 6636 O -22.243475 -13.329179 -1.390694 402 6637 6638 + 6637 H -22.862810 -12.659332 -1.686427 403 6636 + 6638 H -22.410657 -13.599367 -0.469217 403 6636 + 6639 O 23.607826 -9.844602 16.352810 402 6640 6641 + 6640 H 24.370141 -9.837102 16.979270 403 6639 + 6641 H 22.885616 -9.527980 16.925581 403 6639 + 6642 O -17.460421 9.171816 -11.938616 402 6643 6644 + 6643 H -18.218389 8.865436 -11.398928 403 6642 + 6644 H -17.867876 9.968898 -12.335632 403 6642 + 6645 O 2.263863 -17.526491 14.554618 402 6646 6647 + 6646 H 1.859635 -17.896680 15.358713 403 6645 + 6647 H 2.052535 -18.087323 13.764230 403 6645 + 6648 O 27.368617 -13.116454 -17.139830 402 6649 6650 + 6649 H 27.233784 -13.465846 -16.264251 403 6648 + 6650 H 27.362385 -13.865254 -17.806940 403 6648 + 6651 O 16.784972 2.549591 14.309398 402 6652 6653 + 6652 H 17.733190 2.537919 14.322805 403 6651 + 6653 H 16.413277 1.810095 13.861707 403 6651 + 6654 O 21.804761 -2.107242 -5.095741 402 6655 6656 + 6655 H 22.776789 -2.281899 -4.959560 403 6654 + 6656 H 21.413198 -2.898127 -5.388708 403 6654 + 6657 O 14.063924 6.483674 -0.351431 402 6658 6659 + 6658 H 14.941176 6.100507 -0.517796 403 6657 + 6659 H 14.071859 7.050391 0.399753 403 6657 + 6660 O 14.554835 16.507491 9.329558 402 6661 6662 + 6661 H 15.358643 16.591416 9.875030 403 6660 + 6662 H 13.889851 17.088326 9.657109 403 6660 + 6663 O 8.670655 -18.428515 -11.354395 402 6664 6665 + 6664 H 9.496711 -18.254251 -11.776580 403 6663 + 6665 H 8.693110 -18.508570 -10.379319 403 6663 + 6666 O -17.333287 2.077059 19.999340 402 6667 6668 + 6667 H -18.012974 2.265838 19.359237 403 6666 + 6668 H -17.678958 2.658724 20.686523 403 6666 + 6669 O -12.269943 7.557325 8.022561 402 6670 6671 + 6670 H -11.782231 7.901385 7.310410 403 6669 + 6671 H -11.518722 7.369844 8.741429 403 6669 + 6672 O -16.422160 -12.244301 6.857276 402 6673 6674 + 6673 H -16.476236 -12.690789 7.708566 403 6672 + 6674 H -17.265810 -12.438972 6.474023 403 6672 + 6675 O -12.460293 15.701651 -2.123616 402 6676 6677 + 6676 H -12.202263 16.633440 -2.262429 403 6675 + 6677 H -12.915395 15.335750 -2.913659 403 6675 + 6678 O 19.857137 7.435921 -19.855513 402 6679 6680 + 6679 H 19.224411 8.121790 -20.149860 403 6678 + 6680 H 19.459580 7.115365 -18.985221 403 6678 + 6681 O 27.414938 3.220691 12.551587 402 6682 6683 + 6682 H 28.302084 3.292286 12.082110 403 6681 + 6683 H 27.376652 2.288121 12.758098 403 6681 + 6684 O -20.578446 6.501862 -7.543872 402 6685 6686 + 6685 H -21.322455 7.133983 -7.483478 403 6684 + 6686 H -20.905164 5.709027 -7.068017 403 6684 + 6687 O 9.893421 -13.954239 -2.145744 402 6688 6689 + 6688 H 10.845577 -13.887452 -1.806008 403 6687 + 6689 H 9.670044 -13.100245 -2.522670 403 6687 + 6690 O -4.428072 -19.794959 6.392084 402 6691 6692 + 6691 H -3.499634 -19.499125 6.457248 403 6690 + 6692 H -4.796122 -19.302160 7.159538 403 6690 + 6693 O -7.874919 11.488098 -11.872687 402 6694 6695 + 6694 H -7.741906 10.850602 -11.130468 403 6693 + 6695 H -8.663122 11.156415 -12.262641 403 6693 + 6696 O 25.941607 -13.435898 9.799183 402 6697 6698 + 6697 H 26.834803 -13.623931 10.154795 403 6696 + 6698 H 25.332757 -14.073159 10.291155 403 6696 + 6699 O -19.551589 -5.315854 19.441555 402 6700 6701 + 6700 H -19.573638 -5.247652 20.432003 403 6699 + 6701 H -18.874142 -4.641904 19.223175 403 6699 + 6702 O -15.895156 17.865430 12.295752 402 6703 6704 + 6703 H -15.942604 18.800693 12.596548 403 6702 + 6704 H -16.548061 17.362585 12.771509 403 6702 + 6705 O 2.671083 -14.766415 2.401009 402 6706 6707 + 6706 H 1.987603 -14.345575 1.847880 403 6705 + 6707 H 2.531547 -14.517967 3.328895 403 6705 + 6708 O 12.335851 -9.704468 -20.394740 402 6709 6710 + 6709 H 12.648806 -9.830295 -19.492670 403 6708 + 6710 H 11.490958 -10.100623 -20.194535 403 6708 + 6711 O -22.106737 -9.538400 8.455985 402 6712 6713 + 6712 H -21.536209 -9.084366 9.058590 403 6711 + 6713 H -23.017732 -9.207212 8.501551 403 6711 + 6714 O 12.648535 6.444583 -9.932281 402 6715 6716 + 6715 H 13.157813 6.358331 -10.726454 403 6714 + 6716 H 11.747411 6.253342 -10.180418 403 6714 + 6717 O -13.625525 -14.166725 14.041460 402 6718 6719 + 6718 H -13.177614 -14.592522 13.259629 403 6717 + 6719 H -14.592492 -14.334369 13.940732 403 6717 + 6720 O 6.601614 16.498956 -16.461129 402 6721 6722 + 6721 H 7.358480 15.895066 -16.451685 403 6720 + 6722 H 6.023786 16.041896 -17.084703 403 6720 + 6723 O 21.778571 -2.612574 13.360688 402 6724 6725 + 6724 H 22.384822 -2.519802 12.682789 403 6723 + 6725 H 21.622799 -1.672884 13.624001 403 6723 + 6726 O -20.149213 6.013192 6.945622 402 6727 6728 + 6727 H -21.145473 5.909263 6.918876 403 6726 + 6728 H -19.835482 6.282517 6.065703 403 6726 + 6729 O -21.966774 -11.494919 -8.738743 402 6730 6731 + 6730 H -22.851768 -11.211695 -9.113733 403 6729 + 6731 H -21.879165 -10.921961 -8.012191 403 6729 + 6732 O 15.449095 -9.497086 12.201305 402 6733 6734 + 6733 H 16.382306 -9.836986 12.244632 403 6732 + 6734 H 15.422419 -9.084200 11.356115 403 6732 + 6735 O 12.664756 -15.306651 -20.531836 402 6736 6737 + 6736 H 12.034408 -16.012414 -20.359938 403 6735 + 6737 H 12.739209 -14.577278 -19.974973 403 6735 + 6738 O -7.972869 -5.604918 -11.934405 402 6739 6740 + 6739 H -7.601267 -4.885318 -11.379446 403 6738 + 6740 H -8.575310 -6.063681 -11.263704 403 6738 + 6741 O 0.299553 12.700530 -18.524181 402 6742 6743 + 6742 H 0.558430 11.815355 -18.777046 403 6741 + 6743 H -0.711668 12.618485 -18.481012 403 6741 + 6744 O -0.824908 18.918494 -20.332651 402 6745 6746 + 6745 H 0.055729 18.800950 -20.088514 403 6744 + 6746 H -0.726815 18.736133 -21.275575 403 6744 + 6747 O 25.716218 -17.621624 -18.165089 402 6748 6749 + 6748 H 25.183585 -18.348327 -18.615572 403 6747 + 6749 H 26.570805 -18.051277 -17.821631 403 6747 + 6750 O 11.895246 -12.886376 -15.030415 402 6751 6752 + 6751 H 12.581969 -12.241572 -14.789572 403 6750 + 6752 H 12.014494 -13.590976 -14.363464 403 6750 + 6753 O -6.984781 -6.050242 10.699580 402 6754 6755 + 6754 H -6.200372 -6.230567 10.144341 403 6753 + 6755 H -6.715278 -5.563587 11.454374 403 6753 + 6756 O -7.335609 -12.055455 -4.954546 402 6757 6758 + 6757 H -6.870389 -12.537029 -5.731051 403 6756 + 6758 H -8.034369 -11.614893 -5.410536 403 6756 + 6759 O 7.328653 12.351276 10.622525 402 6760 6761 + 6760 H 7.205722 12.826673 9.764783 403 6759 + 6761 H 6.491360 12.585679 11.094427 403 6759 + 6762 O -2.064418 15.964062 4.897369 402 6763 6764 + 6763 H -1.989044 16.110456 3.944429 403 6762 + 6764 H -1.188158 16.010465 5.256453 403 6762 + 6765 O 10.673140 16.947190 -7.298199 402 6766 6767 + 6766 H 11.053321 16.848368 -6.437645 403 6765 + 6767 H 9.833705 16.415071 -7.530378 403 6765 + 6768 O 25.146955 -10.850377 -5.894794 402 6769 6770 + 6769 H 25.793466 -10.144367 -5.792885 403 6768 + 6770 H 25.341761 -11.315139 -6.748470 403 6768 + 6771 O -20.898709 -20.024244 -0.432532 402 6772 6773 + 6772 H -21.327485 -20.809324 -0.731327 403 6771 + 6773 H -20.384646 -19.736744 -1.159428 403 6771 + 6774 O 15.773125 -11.828239 1.267979 402 6775 6776 + 6775 H 15.082308 -11.485912 1.791000 403 6774 + 6776 H 16.210809 -11.047975 0.843250 403 6774 + 6777 O -25.459831 -14.049130 16.602221 402 6778 6779 + 6778 H -25.659268 -15.033606 16.753032 403 6777 + 6779 H -26.167299 -13.609133 17.155971 403 6777 + 6780 O -15.346212 9.776118 0.552706 402 6781 6782 + 6781 H -14.861031 10.583944 0.897097 403 6780 + 6782 H -15.499398 9.230659 1.360288 403 6780 + 6783 O 1.515239 -10.027493 16.408903 402 6784 6785 + 6784 H 2.112245 -9.685145 15.772127 403 6783 + 6785 H 1.563862 -10.961534 16.268707 403 6783 + 6786 O 8.730778 -2.046469 -16.855487 402 6787 6788 + 6787 H 8.003213 -2.349766 -16.293070 403 6786 + 6788 H 8.893912 -1.127143 -16.700440 403 6786 + 6789 O -12.659858 10.277753 9.764551 402 6790 6791 + 6790 H -12.954976 10.194740 10.671493 403 6789 + 6791 H -12.294313 11.185370 9.686563 403 6789 + 6792 O 13.241019 7.614156 1.958471 402 6793 6794 + 6793 H 13.989186 7.821908 2.548064 403 6792 + 6794 H 12.569506 7.225025 2.564990 403 6792 + 6795 O 18.743445 -1.851686 14.221199 402 6796 6797 + 6796 H 19.241705 -2.155912 15.013052 403 6795 + 6797 H 17.934973 -2.360999 14.283218 403 6795 + 6798 O 20.097738 14.045420 -3.353931 402 6799 6800 + 6799 H 20.264111 13.632005 -4.240012 403 6798 + 6800 H 19.782670 14.876950 -3.580329 403 6798 + 6801 O 22.656523 -13.025771 -7.851202 402 6802 6803 + 6802 H 23.058494 -13.682024 -8.427211 403 6801 + 6803 H 22.939496 -13.206983 -6.927788 403 6801 + 6804 O 22.687429 4.701978 5.232797 402 6805 6806 + 6805 H 22.127391 3.970799 5.568822 403 6804 + 6806 H 22.543397 5.316387 5.948219 403 6804 + 6807 O 23.649228 -7.915795 -3.510236 402 6808 6809 + 6808 H 22.801078 -8.238516 -3.339971 403 6807 + 6809 H 23.474938 -7.503073 -4.391727 403 6807 + 6810 O -6.616017 -20.555130 17.274390 402 6811 6812 + 6811 H -6.785872 -19.593361 17.044755 403 6810 + 6812 H -6.639098 -20.935653 16.386762 403 6810 + 6813 O 11.575769 10.993842 8.632733 402 6814 6815 + 6814 H 11.631285 10.248287 9.251562 403 6813 + 6815 H 11.054687 11.776369 9.032913 403 6813 + 6816 O -14.897591 -13.741408 -8.424343 402 6817 6818 + 6817 H -13.944044 -13.521919 -8.374624 403 6816 + 6818 H -15.245652 -13.416716 -9.247098 403 6816 + 6819 O -7.606286 -16.239672 5.296165 402 6820 6821 + 6820 H -8.529013 -16.377754 5.125689 403 6819 + 6821 H -7.372109 -15.298609 5.089587 403 6819 + 6822 O 21.651688 -6.687757 -17.914010 402 6823 6824 + 6823 H 21.631109 -7.371723 -17.250699 403 6822 + 6824 H 22.595382 -6.421930 -17.913376 403 6822 + 6825 O 8.244086 -0.418132 8.413538 402 6826 6827 + 6826 H 8.150004 -1.042562 7.678730 403 6825 + 6827 H 7.835426 -0.797019 9.189825 403 6825 + 6828 O 16.479760 -10.801798 -19.696932 402 6829 6830 + 6829 H 17.075192 -11.093875 -20.402321 403 6828 + 6830 H 17.056365 -10.719762 -18.940382 403 6828 + 6831 O -0.277774 0.459271 -13.592265 402 6832 6833 + 6832 H 0.641958 0.154550 -13.512461 403 6831 + 6833 H -0.452113 1.346343 -13.286369 403 6831 + 6834 O -6.542284 15.376168 4.177517 402 6835 6836 + 6835 H -5.816160 15.112821 4.810192 403 6834 + 6836 H -6.899831 14.592226 3.628797 403 6834 + 6837 O -20.635866 7.001713 -1.480479 402 6838 6839 + 6838 H -21.373222 6.994284 -2.078088 403 6837 + 6839 H -20.006067 6.359671 -1.951231 403 6837 + 6840 O -13.639335 3.376760 17.002766 402 6841 6842 + 6841 H -13.969979 2.665180 17.593575 403 6840 + 6842 H -13.046017 3.905659 17.530455 403 6840 + 6843 O -6.547337 20.684985 14.541933 402 6844 6845 + 6844 H -6.972273 21.348698 14.071679 403 6843 + 6845 H -5.602331 20.918763 14.522709 403 6843 + 6846 O -2.497800 -13.782262 -4.791828 402 6847 6848 + 6847 H -1.576617 -13.507624 -4.869174 403 6846 + 6848 H -2.714797 -14.013702 -5.709334 403 6846 + 6849 O -1.112625 18.563757 18.790030 402 6850 6851 + 6850 H -0.288236 18.142534 18.527379 403 6849 + 6851 H -0.946536 19.452779 18.744542 403 6849 + 6852 O -13.988854 -2.769276 -13.122084 402 6853 6854 + 6853 H -13.598926 -2.700606 -13.943868 403 6852 + 6854 H -14.937873 -2.607884 -13.208114 403 6852 + 6855 O -16.715661 8.750744 -17.681497 402 6856 6857 + 6856 H -15.798116 8.603619 -18.047851 403 6855 + 6857 H -16.635460 9.420085 -17.000771 403 6855 + 6858 O 2.991113 -12.748536 9.631899 402 6859 6860 + 6859 H 2.533802 -13.278079 8.996870 403 6858 + 6860 H 2.583180 -11.923543 9.637997 403 6858 + 6861 O -27.414426 -12.634511 18.337817 402 6862 6863 + 6862 H -28.225666 -12.744824 17.838871 403 6861 + 6863 H -27.706128 -12.906300 19.286418 403 6861 + 6864 O 11.850131 -20.736745 10.117226 402 6865 6866 + 6865 H 12.209918 -19.885422 9.990598 403 6864 + 6866 H 12.449458 -21.164159 10.776006 403 6864 + 6867 O 16.900404 -9.611117 0.299881 402 6868 6869 + 6868 H 17.702920 -9.200486 0.626455 403 6867 + 6869 H 16.211832 -8.949525 0.285394 403 6867 + 6870 O 1.300636 17.476583 -19.357702 402 6871 6872 + 6871 H 1.244601 16.535623 -19.680589 403 6870 + 6872 H 2.229065 17.802299 -19.528512 403 6870 + 6873 O -13.442641 6.855380 -12.602329 402 6874 6875 + 6874 H -13.248683 5.960155 -12.345808 403 6873 + 6875 H -12.964930 7.379163 -11.927446 403 6873 + 6876 O 10.508692 10.781998 13.857653 402 6877 6878 + 6877 H 10.700750 11.227397 13.025331 403 6876 + 6878 H 11.274159 10.169036 14.047871 403 6876 + 6879 O -15.161111 15.497808 -1.075417 402 6880 6881 + 6880 H -14.941306 16.067302 -1.834212 403 6879 + 6881 H -14.307102 15.425376 -0.587763 403 6879 + 6882 O 26.516448 19.605204 -1.401155 402 6883 6884 + 6883 H 27.409955 19.971686 -1.420282 403 6882 + 6884 H 26.420947 18.971191 -0.667802 403 6882 + 6885 O -0.954004 8.187819 13.771505 402 6886 6887 + 6886 H -0.458409 7.469182 14.137804 403 6885 + 6887 H -1.797548 7.882182 13.530929 403 6885 + 6888 O 15.694940 -16.566561 10.671838 402 6889 6890 + 6889 H 15.180482 -16.576742 9.844033 403 6888 + 6890 H 14.966563 -16.548505 11.318780 403 6888 + 6891 O 18.598747 3.441754 -19.980603 402 6892 6893 + 6892 H 19.607131 3.445422 -19.714075 403 6891 + 6893 H 18.629619 3.587760 -20.937873 403 6891 + 6894 O -4.101725 20.626483 18.518698 402 6895 6896 + 6895 H -4.832741 21.173287 18.195756 403 6894 + 6896 H -3.506641 21.284151 19.004490 403 6894 + 6897 O -1.622747 20.903759 -10.623135 402 6898 6899 + 6898 H -1.749055 20.907257 -9.665824 403 6897 + 6899 H -2.518273 20.806241 -11.004696 403 6897 + 6900 O -2.179807 -14.291095 -12.926864 402 6901 6902 + 6901 H -2.705153 -14.473812 -12.111290 403 6900 + 6902 H -1.495280 -13.773858 -12.562680 403 6900 + 6903 O -21.678830 15.695505 11.326422 402 6904 6905 + 6904 H -21.490132 16.123832 12.219822 403 6903 + 6905 H -22.555374 16.000330 11.105890 403 6903 + 6906 O 20.387528 -15.104299 -14.428654 402 6907 6908 + 6907 H 19.639614 -14.550582 -14.652181 403 6906 + 6908 H 20.966724 -14.615439 -13.782083 403 6906 + 6909 O 8.543989 2.061633 14.171285 402 6910 6911 + 6910 H 8.138366 1.205164 14.195988 403 6909 + 6911 H 8.018048 2.600851 14.790181 403 6909 + 6912 O -14.889828 7.565748 -1.232224 402 6913 6914 + 6913 H -15.277980 8.149588 -0.532147 403 6912 + 6914 H -14.157076 7.163538 -0.720742 403 6912 + 6915 O 6.890439 6.835565 10.786892 402 6916 6917 + 6916 H 7.316224 7.702174 10.597929 403 6915 + 6917 H 7.041785 6.699181 11.734956 403 6915 + 6918 O -23.725715 6.589830 20.135978 402 6919 6920 + 6919 H -24.326282 5.920341 20.500508 403 6918 + 6920 H -24.274788 7.300563 19.971121 403 6918 + 6921 O -0.448883 -20.864583 -14.617458 402 6922 6923 + 6922 H 0.071192 -21.697111 -14.370110 403 6921 + 6923 H -0.336801 -20.602783 -15.491876 403 6921 + 6924 O 4.752131 -18.759171 16.224472 402 6925 6926 + 6925 H 4.247100 -17.909089 16.159151 403 6924 + 6926 H 5.497199 -18.596379 16.767517 403 6924 + 6927 O 25.551466 11.024091 14.835821 402 6928 6929 + 6928 H 26.097565 10.360826 15.318240 403 6927 + 6929 H 25.868265 11.894670 15.113284 403 6927 + 6930 O -13.792632 -0.131648 -11.968031 402 6931 6932 + 6931 H -14.069742 -1.037349 -12.273373 403 6930 + 6932 H -14.587746 0.465719 -12.016945 403 6930 + 6933 O -2.710690 15.293627 -0.278680 402 6934 6935 + 6934 H -2.998969 15.960057 0.331443 403 6933 + 6935 H -3.386842 14.623069 -0.355634 403 6933 + 6936 O -17.248233 -20.121844 -4.059452 402 6937 6938 + 6937 H -17.172414 -21.044463 -4.251654 403 6936 + 6938 H -16.877225 -20.034684 -3.174803 403 6936 + 6939 O 23.843575 9.736974 -14.350198 402 6940 6941 + 6940 H 23.682322 8.979239 -15.046519 403 6939 + 6941 H 23.367386 9.481782 -13.520758 403 6939 + 6942 O -11.977920 -13.866924 -9.096345 402 6943 6944 + 6943 H -12.034457 -14.762049 -8.738542 403 6942 + 6944 H -11.033924 -13.842490 -9.319192 403 6942 + 6945 O -20.844885 -20.673768 11.904219 402 6946 6947 + 6946 H -21.211544 -21.565612 12.158518 403 6945 + 6947 H -21.251746 -20.526654 11.038182 403 6945 + 6948 O 10.501648 -10.083276 10.087293 402 6949 6950 + 6949 H 10.918566 -9.250606 10.394612 403 6948 + 6950 H 9.992333 -9.906650 9.274003 403 6948 + 6951 O -19.115579 -4.779064 -19.789173 402 6952 6953 + 6952 H -18.214269 -4.399767 -19.923178 403 6951 + 6953 H -19.400662 -4.666966 -18.902157 403 6951 + 6954 O 27.292959 4.591920 -14.450094 402 6955 6956 + 6955 H 27.857326 4.638750 -13.673258 403 6954 + 6956 H 26.302663 4.467257 -14.132617 403 6954 + 6957 O -15.973482 -19.623868 10.652463 402 6958 6959 + 6958 H -15.396164 -19.929927 9.974366 403 6957 + 6959 H -16.843194 -19.544182 10.235192 403 6957 + 6960 O -24.224954 -2.728737 10.935846 402 6961 6962 + 6961 H -23.262685 -2.710705 11.036848 403 6960 + 6962 H -24.594330 -3.621981 10.847310 403 6960 + 6963 O -10.392772 -14.962488 2.206954 402 6964 6965 + 6964 H -10.142273 -15.819733 2.617268 403 6963 + 6965 H -9.689412 -14.869628 1.550246 403 6963 + 6966 O 23.781651 14.549010 -15.425504 402 6967 6968 + 6967 H 23.508500 15.178591 -16.172525 403 6966 + 6968 H 23.231402 13.779403 -15.566088 403 6966 + 6969 O -16.655122 13.378532 -2.256893 402 6970 6971 + 6970 H -15.876557 13.842392 -1.809556 403 6969 + 6971 H -17.352965 14.010234 -2.115536 403 6969 + 6972 O 17.907598 17.234287 -12.510154 402 6973 6974 + 6973 H 17.700495 16.802779 -13.342124 403 6972 + 6974 H 17.297348 17.961204 -12.489351 403 6972 + 6975 O 17.427023 -12.078823 9.916700 402 6976 6977 + 6976 H 16.525879 -12.070244 9.636554 403 6975 + 6977 H 17.909679 -12.239509 9.119337 403 6975 + 6978 O -19.359847 6.057050 19.624868 402 6979 6980 + 6979 H -19.814369 5.574360 18.904014 403 6978 + 6980 H -19.255770 6.911903 19.182635 403 6978 + 6981 O 18.674024 -19.624270 17.522963 402 6982 6983 + 6982 H 17.740156 -19.461855 17.682137 403 6981 + 6983 H 18.867385 -19.535332 16.599150 403 6981 + 6984 O 20.025827 3.814045 -9.622919 402 6985 6986 + 6985 H 19.683972 4.038069 -10.485997 403 6984 + 6986 H 20.937506 3.543209 -9.811005 403 6984 + 6987 O 5.470940 6.984171 8.109869 402 6988 6989 + 6988 H 5.850717 7.846581 8.087996 403 6987 + 6989 H 5.945843 6.559192 8.827716 403 6987 + 6990 O -10.808039 20.531242 -16.312076 402 6991 6992 + 6991 H -10.302470 21.104206 -15.760708 403 6990 + 6992 H -10.017446 20.227222 -16.784699 403 6990 + 6993 O -11.027875 -4.920821 17.870938 402 6994 6995 + 6994 H -10.325336 -4.445713 17.369166 403 6993 + 6995 H -11.377886 -5.529192 17.224974 403 6993 + 6996 O -20.371671 10.114815 16.255481 402 6997 6998 + 6997 H -20.580138 10.101355 15.263993 403 6996 + 6998 H -20.344545 11.071578 16.437819 403 6996 + 6999 O 23.653520 3.436168 1.325510 402 7000 7001 + 7000 H 23.536106 2.474980 1.098717 403 6999 + 7001 H 23.860683 3.796523 0.414552 403 6999 + 7002 O -21.567514 -2.949387 5.091162 402 7003 7004 + 7003 H -22.071317 -3.738968 4.916553 403 7002 + 7004 H -22.336939 -2.390166 5.390630 403 7002 + 7005 O 22.554166 -9.402044 -6.100872 402 7006 7007 + 7006 H 23.431323 -9.766839 -6.077907 403 7005 + 7007 H 22.697180 -8.479613 -6.418284 403 7005 + 7008 O -22.569113 -4.640399 13.826281 402 7009 7010 + 7009 H -23.358557 -5.049193 13.550678 403 7008 + 7010 H -22.257880 -5.191735 14.515317 403 7008 + 7011 O -2.385157 12.751460 -2.313524 402 7012 7013 + 7012 H -1.730031 13.357140 -2.644514 403 7011 + 7013 H -1.978595 12.282671 -1.585523 403 7011 + 7014 O -26.161645 14.565358 1.232440 402 7015 7016 + 7015 H -26.706603 13.814255 1.347347 403 7014 + 7016 H -26.622850 15.329972 1.567273 403 7014 + 7017 O 1.453589 -9.489501 -18.511074 402 7018 7019 + 7018 H 1.470127 -10.349425 -18.991155 403 7017 + 7019 H 1.973543 -8.965754 -19.091787 403 7017 + 7020 O -0.660378 -18.577536 -12.938447 402 7021 7022 + 7021 H -0.732583 -19.053338 -12.113581 403 7020 + 7022 H -0.517701 -19.272917 -13.578982 403 7020 + 7023 O 14.312654 12.150861 -6.246651 402 7024 7025 + 7024 H 14.287806 12.704737 -5.491569 403 7023 + 7025 H 15.175580 11.801455 -6.299294 403 7023 + 7026 O 18.998590 6.532260 -0.632888 402 7027 7028 + 7027 H 18.366049 5.787028 -0.799484 403 7026 + 7028 H 19.311853 6.485139 0.272589 403 7026 + 7029 O 5.329915 17.883588 20.342830 402 7030 7031 + 7030 H 4.796701 18.410992 19.709020 403 7029 + 7031 H 4.770971 17.852635 21.154570 403 7029 + 7032 O 24.723592 -6.944303 -11.741165 402 7033 7034 + 7033 H 24.780327 -6.008688 -11.867155 403 7032 + 7034 H 24.690407 -7.329055 -12.639425 403 7032 + 7035 O -23.122003 4.618796 18.181339 402 7036 7037 + 7036 H -23.209287 5.265752 18.869409 403 7035 + 7037 H -23.988906 4.549652 17.803581 403 7035 + 7038 O 8.709146 17.478249 5.929770 402 7039 7040 + 7039 H 7.992855 18.166454 5.872705 403 7038 + 7040 H 9.532770 18.014027 5.879190 403 7038 + 7041 O -25.145193 10.967387 14.467030 402 7042 7043 + 7042 H -25.638192 11.462461 13.811080 403 7041 + 7043 H -25.115880 11.602045 15.194844 403 7041 + 7044 O -6.270672 10.298692 -9.326284 402 7045 7046 + 7045 H -6.326041 9.841909 -8.460997 403 7044 + 7046 H -5.298295 10.155581 -9.629880 403 7044 + 7047 O 8.331282 15.667208 -4.044961 402 7048 7049 + 7048 H 8.081425 16.068754 -3.248975 403 7047 + 7049 H 7.784433 16.176579 -4.661216 403 7047 + 7050 O -4.605111 3.075866 17.330627 402 7051 7052 + 7051 H -4.999875 2.960715 16.481841 403 7050 + 7052 H -5.159040 3.212840 18.083160 403 7050 + 7053 O 14.687017 -3.513814 10.903431 402 7054 7055 + 7054 H 14.499277 -3.337699 11.823116 403 7053 + 7055 H 14.262838 -4.331541 10.602044 403 7053 + 7056 O -20.872612 6.379762 10.816794 402 7057 7058 + 7057 H -20.860809 7.234769 10.341581 403 7056 + 7058 H -20.061300 6.341520 11.384808 403 7056 + 7059 O 7.161896 -4.360755 17.634105 402 7060 7061 + 7060 H 8.175987 -4.400233 17.464973 403 7059 + 7061 H 7.057446 -4.853463 18.480499 403 7059 + 7062 O -3.475038 11.316770 16.798166 402 7063 7064 + 7063 H -2.755042 10.845936 17.155120 403 7062 + 7064 H -3.489190 11.054731 15.856176 403 7062 + 7065 O 15.663266 8.649743 3.198716 402 7066 7067 + 7066 H 15.359027 9.298705 3.810376 403 7065 + 7067 H 16.192400 8.008866 3.672568 403 7065 + 7068 O 5.436707 -20.461241 11.921265 402 7069 7070 + 7069 H 5.119701 -19.606856 11.530637 403 7068 + 7070 H 4.713208 -20.630626 12.549382 403 7068 + 7071 O -4.801212 -17.868960 -3.936676 402 7072 7073 + 7072 H -5.438715 -17.659702 -4.657529 403 7071 + 7073 H -4.229156 -18.589597 -4.194370 403 7071 + 7074 O -15.253442 11.238290 -10.212163 402 7075 7076 + 7075 H -14.642285 11.918974 -10.588009 403 7074 + 7076 H -16.099309 11.643007 -10.393989 403 7074 + 7077 O 26.686176 10.830985 20.584564 402 7078 7079 + 7078 H 26.369951 11.360874 21.358365 403 7077 + 7079 H 26.509688 9.944710 20.906243 403 7077 + 7080 O 12.561683 17.569279 18.161912 402 7081 7082 + 7081 H 12.373224 16.635553 17.927044 403 7080 + 7082 H 11.953579 17.940076 18.749558 403 7080 + 7083 O -7.212093 -10.307008 17.334494 402 7084 7085 + 7084 H -6.512620 -10.511909 17.944932 403 7083 + 7085 H -7.614860 -11.144180 17.014381 403 7083 + 7086 O 1.066613 3.381658 18.538737 402 7087 7088 + 7087 H 1.472142 3.810443 19.302366 403 7086 + 7088 H 0.121217 3.213227 18.686468 403 7086 + 7089 O 26.591569 20.388220 15.314096 402 7090 7091 + 7090 H 27.027629 19.549241 15.003737 403 7089 + 7091 H 25.677162 20.106742 15.492223 403 7089 + 7092 O -12.980829 3.037173 -5.149300 402 7093 7094 + 7093 H -13.518049 2.271141 -5.381098 403 7092 + 7094 H -13.015144 3.271986 -4.233059 403 7092 + 7095 O -15.670290 -19.461795 -8.693893 402 7096 7097 + 7096 H -15.312346 -19.371467 -7.762922 403 7095 + 7097 H -15.700912 -18.579237 -9.112271 403 7095 + 7098 O 18.498310 -6.951013 11.923309 402 7099 7100 + 7099 H 19.331146 -6.980278 12.293062 403 7098 + 7100 H 17.952458 -6.708175 12.679535 403 7098 + 7101 O 22.848965 14.115566 0.206953 402 7102 7103 + 7102 H 23.127347 14.768732 -0.415947 403 7101 + 7103 H 23.434401 14.218348 0.991573 403 7101 + 7104 O -23.977260 16.643521 -8.138268 402 7105 7106 + 7105 H -24.563932 16.858836 -8.896849 403 7104 + 7106 H -23.095154 16.760370 -8.386216 403 7104 + 7107 O -26.584391 -6.397854 5.547650 402 7108 7109 + 7108 H -25.925294 -7.061435 5.741608 403 7107 + 7109 H -26.133892 -5.544387 5.442967 403 7107 + 7110 O 2.060216 -10.468459 10.640375 402 7111 7112 + 7111 H 2.489904 -9.711105 10.219505 403 7110 + 7112 H 1.131111 -10.283322 10.616360 403 7110 + 7113 O 5.954667 9.758583 -20.555530 402 7114 7115 + 7114 H 6.264304 10.543474 -21.120622 403 7113 + 7115 H 5.484413 9.147185 -21.197897 403 7113 + 7116 O 24.786566 -15.292270 2.666103 402 7117 7118 + 7117 H 23.947578 -15.213745 2.181575 403 7116 + 7118 H 24.621364 -16.114647 3.180504 403 7116 + 7119 O -9.238549 4.246640 18.608373 402 7120 7121 + 7120 H -8.516205 4.915950 18.512268 403 7119 + 7121 H -8.905672 3.343488 18.421048 403 7119 + 7122 O 4.458783 0.783326 15.910622 402 7123 7124 + 7123 H 4.333357 -0.156607 15.829450 403 7122 + 7124 H 5.377583 0.813141 16.228468 403 7122 + 7125 O 2.440654 19.498822 -16.520052 402 7126 7127 + 7126 H 1.894281 18.987314 -15.882707 403 7125 + 7127 H 2.550447 18.871750 -17.222238 403 7125 + 7128 O -14.387304 8.489545 5.108260 402 7129 7130 + 7129 H -14.330824 9.314254 5.570879 403 7128 + 7130 H -13.611936 7.964241 5.306370 403 7128 + 7131 O -5.680779 -19.561928 -0.391390 402 7132 7133 + 7132 H -6.492940 -19.118143 -0.731363 403 7131 + 7133 H -5.761503 -20.446667 -0.611520 403 7131 + 7134 O 0.364483 -0.976730 20.596640 402 7135 7136 + 7135 H 0.190818 -1.943299 20.568078 403 7134 + 7136 H -0.296384 -0.570410 19.967598 403 7134 + 7137 O -20.103572 15.327950 -3.864750 402 7138 7139 + 7138 H -20.721760 16.087200 -3.977948 403 7137 + 7139 H -19.620299 15.411599 -4.730333 403 7137 + 7140 O 7.762229 -15.911349 -12.044815 402 7141 7142 + 7141 H 8.618390 -15.446157 -11.951239 403 7140 + 7142 H 8.056718 -16.844883 -11.932849 403 7140 + 7143 O -14.271772 -19.114636 20.444087 402 7144 7145 + 7144 H -13.631359 -18.451185 20.013255 403 7143 + 7145 H -14.788312 -18.613074 21.058254 403 7143 + 7146 O -17.296785 -16.270141 -5.846230 402 7147 7148 + 7147 H -16.661324 -16.986407 -5.791657 403 7146 + 7148 H -17.698563 -16.270611 -6.699261 403 7146 + 7149 O 5.461014 -17.908610 10.258639 402 7150 7151 + 7150 H 6.041339 -18.066045 9.495427 403 7149 + 7151 H 5.907462 -17.113295 10.672048 403 7149 + 7152 O -6.579640 -20.864919 -3.728078 402 7153 7154 + 7153 H -6.197014 -21.129682 -2.892954 403 7152 + 7154 H -5.867159 -20.529771 -4.364102 403 7152 + 7155 O 15.290566 -16.899037 3.541007 402 7156 7157 + 7156 H 15.456923 -17.854501 3.506824 403 7155 + 7157 H 14.682578 -16.661722 4.258103 403 7155 + 7158 O -8.595092 -1.638190 20.084084 402 7159 7160 + 7159 H -8.261779 -2.590969 20.168832 403 7158 + 7160 H -7.852015 -1.108351 20.332316 403 7158 + 7161 O -20.323788 -5.436750 0.324161 402 7162 7163 + 7162 H -20.170009 -5.941054 1.094644 403 7161 + 7163 H -21.208252 -5.031900 0.601954 403 7161 + 7164 O -2.393237 8.004242 -11.498413 402 7165 7166 + 7165 H -2.950404 8.660356 -11.054135 403 7164 + 7166 H -3.061318 7.581791 -12.073133 403 7164 + 7167 O -22.912771 3.860494 -12.441206 402 7168 7169 + 7168 H -23.451777 3.037762 -12.348507 403 7167 + 7169 H -22.899565 4.032930 -13.430208 403 7167 + 7170 O 20.362995 17.824512 -13.264003 402 7171 7172 + 7171 H 19.551615 17.496626 -12.844707 403 7170 + 7172 H 20.082478 18.300222 -14.079166 403 7170 + 7173 O -24.585913 -0.746630 -0.896798 402 7174 7175 + 7174 H -24.470331 -1.075027 -1.802806 403 7173 + 7175 H -23.819676 -0.946255 -0.373167 403 7173 + 7176 O -19.535789 -9.056148 -13.988499 402 7177 7178 + 7177 H -19.846462 -8.673779 -13.166776 403 7176 + 7178 H -19.115510 -8.309283 -14.534612 403 7176 + 7179 O 14.390022 6.679518 12.730957 402 7180 7181 + 7180 H 15.232081 6.289813 12.946155 403 7179 + 7181 H 14.506655 7.667961 12.798775 403 7179 + 7182 O -13.116074 -0.366672 20.319004 402 7183 7184 + 7183 H -12.270792 -0.638533 19.918398 403 7182 + 7184 H -13.671647 -1.133311 20.295523 403 7182 + 7185 O -8.591511 -19.336122 8.863799 402 7186 7187 + 7186 H -9.117090 -20.010877 8.426692 403 7185 + 7187 H -7.862918 -19.753372 9.330648 403 7185 + 7188 O 17.402278 20.652639 13.900402 402 7189 7190 + 7189 H 17.697788 21.603581 13.957892 403 7188 + 7190 H 17.312316 20.500438 12.944824 403 7188 + 7191 O 8.201262 9.483818 13.348516 402 7192 7193 + 7192 H 7.444873 10.096390 13.607594 403 7191 + 7193 H 8.957598 10.011937 13.627746 403 7191 + 7194 O 7.585535 14.800848 -12.327563 402 7195 7196 + 7195 H 7.057327 14.353832 -11.664194 403 7194 + 7196 H 7.019891 15.502887 -12.695142 403 7194 + 7197 O -25.423194 -2.683175 -19.281520 402 7198 7199 + 7198 H -25.154720 -3.154251 -18.493055 403 7197 + 7199 H -24.615481 -2.633480 -19.773081 403 7197 + 7200 O 19.725045 -13.114787 8.444878 402 7201 7202 + 7201 H 19.513124 -14.034339 8.634210 403 7200 + 7202 H 20.698306 -13.102042 8.543928 403 7200 + 7203 O 20.099503 -20.282525 -15.985101 402 7204 7205 + 7204 H 20.708189 -19.889578 -15.319196 403 7203 + 7205 H 19.393142 -19.575319 -15.986140 403 7203 + 7206 O 12.771061 16.100563 -19.111418 402 7207 7208 + 7207 H 12.131597 16.778356 -19.314806 403 7206 + 7208 H 12.464661 15.303336 -19.572804 403 7206 + 7209 O 7.091753 -14.703139 17.991009 402 7210 7211 + 7210 H 7.807603 -15.309333 17.938259 403 7209 + 7211 H 7.194027 -14.118016 17.231754 403 7209 + 7212 O -22.592481 8.686176 -7.047127 402 7213 7214 + 7213 H -22.216240 9.064017 -6.202984 403 7212 + 7214 H -23.491060 9.070100 -7.232883 403 7212 + 7215 O -4.638462 -13.691402 17.535113 402 7216 7217 + 7216 H -4.741933 -14.552763 17.998987 403 7215 + 7217 H -3.917812 -13.768318 16.891949 403 7215 + 7218 O 15.674081 -9.755387 -16.113189 402 7219 7220 + 7219 H 16.400378 -9.301702 -15.729512 403 7218 + 7220 H 15.141124 -9.061926 -16.542582 403 7218 + 7221 O -13.702316 -19.909047 -12.268941 402 7222 7223 + 7222 H -14.359478 -19.319853 -12.555858 403 7221 + 7223 H -14.123812 -20.688800 -11.912022 403 7221 + 7224 O 24.541571 12.760808 8.882057 402 7225 7226 + 7225 H 24.177431 13.512218 9.353984 403 7224 + 7226 H 24.288780 12.867460 7.942115 403 7224 + 7227 O -7.687548 20.108508 10.397741 402 7228 7229 + 7228 H -6.786045 20.459581 10.465576 403 7227 + 7229 H -7.840032 19.590481 9.619893 403 7227 + 7230 O 17.691564 14.211194 -11.948720 402 7231 7232 + 7231 H 16.837678 14.621970 -11.842799 403 7230 + 7232 H 18.118330 14.755742 -12.626475 403 7230 + 7233 O 21.348057 -7.329463 -13.375832 402 7234 7235 + 7234 H 21.593345 -6.492239 -13.815720 403 7233 + 7235 H 21.736068 -7.343951 -12.513154 403 7233 + 7236 O -19.887601 4.039241 4.011716 402 7237 7238 + 7237 H -20.804227 3.899388 4.382950 403 7236 + 7238 H -19.888370 5.029157 3.892591 403 7236 + 7239 O -25.084134 8.583682 -19.308703 402 7240 7241 + 7240 H -25.512658 8.302589 -20.191094 403 7239 + 7241 H -24.552230 7.802502 -19.104750 403 7239 + 7242 O 9.783143 -8.944234 15.919722 402 7243 7244 + 7243 H 9.846305 -9.847677 16.313657 403 7242 + 7244 H 10.422901 -8.539313 16.532052 403 7242 + 7245 O 24.921152 14.233454 -9.328043 402 7246 7247 + 7246 H 25.485037 14.435637 -8.538860 403 7245 + 7247 H 24.550831 15.052607 -9.617520 403 7245 + 7248 O -5.336150 -19.944956 -15.675499 402 7249 7250 + 7249 H -4.550070 -20.475028 -15.352798 403 7248 + 7250 H -4.968558 -19.050199 -15.973828 403 7248 + 7251 O -15.773463 -12.281833 -13.129558 402 7252 7253 + 7252 H -15.686354 -12.889867 -12.384071 403 7251 + 7253 H -15.452029 -12.783419 -13.894154 403 7251 + 7254 O -4.300139 -7.123836 -2.160106 402 7255 7256 + 7255 H -3.342814 -7.235681 -2.390788 403 7254 + 7256 H -4.824947 -7.659223 -2.750865 403 7254 + 7257 O -25.789560 20.874236 19.526065 402 7258 7259 + 7258 H -24.843357 21.124661 19.555308 403 7257 + 7259 H -26.065421 21.149679 18.673765 403 7257 + 7260 O -9.146229 1.424908 -20.523854 402 7261 7262 + 7261 H -10.001499 1.119683 -20.181523 403 7260 + 7262 H -8.546249 0.921170 -20.019617 403 7260 + 7263 O 26.101075 5.848590 12.988450 402 7264 7265 + 7264 H 26.554693 5.084410 12.637458 403 7263 + 7265 H 25.161381 5.669725 12.803554 403 7263 + 7266 O 9.006687 19.040346 -18.186210 402 7267 7268 + 7267 H 8.065932 18.907108 -18.115528 403 7266 + 7268 H 9.047297 19.909251 -18.666859 403 7266 + 7269 O -7.293872 14.178171 -1.883075 402 7270 7271 + 7270 H -6.467767 14.351226 -2.386146 403 7269 + 7271 H -7.610529 15.055318 -1.621187 403 7269 + 7272 O -6.991462 19.787403 0.500962 402 7273 7274 + 7273 H -6.438660 19.949638 1.223968 403 7272 + 7274 H -7.711116 19.103046 0.704655 403 7272 + 7275 O 27.160597 -2.308726 -10.478195 402 7276 7277 + 7276 H 26.892593 -1.628933 -9.894058 403 7275 + 7277 H 26.370866 -2.910166 -10.699907 403 7275 + 7278 O 20.720937 15.282200 -14.602248 402 7279 7280 + 7279 H 19.787625 15.378072 -14.861312 403 7278 + 7280 H 21.253153 16.033456 -14.917484 403 7278 + 7281 O -1.717777 3.126430 19.684869 402 7282 7283 + 7282 H -2.457020 3.742545 19.704262 403 7281 + 7283 H -1.981408 2.239558 19.670325 403 7281 + 7284 O -14.236932 -8.531350 -17.888137 402 7285 7286 + 7285 H -13.483311 -8.743594 -17.293313 403 7284 + 7286 H -14.879621 -9.247417 -17.747177 403 7284 + 7287 O -4.783415 -4.020396 -20.532866 402 7288 7289 + 7288 H -4.012136 -4.566525 -20.414031 403 7287 + 7289 H -5.530185 -4.500179 -20.351823 403 7287 + 7290 O -13.666695 2.341198 -19.917613 402 7291 7292 + 7291 H -13.647430 2.522072 -20.842149 403 7290 + 7292 H -14.523681 2.756089 -19.651511 403 7290 + 7293 O 3.688675 -20.632144 14.338255 402 7294 7295 + 7294 H 4.124765 -20.055049 14.958708 403 7293 + 7295 H 3.773276 -21.474844 14.693545 403 7293 + 7296 O -20.711810 11.153254 -5.295425 402 7297 7298 + 7297 H -20.997628 10.543621 -4.576628 403 7296 + 7298 H -20.872806 11.978037 -4.877765 403 7296 + 7299 O 24.053294 -19.987538 -18.448521 402 7300 7301 + 7300 H 23.997797 -20.379984 -19.321399 403 7299 + 7301 H 24.605029 -20.616521 -17.920358 403 7299 + 7302 O 18.893096 0.346665 4.419514 402 7303 7304 + 7303 H 18.836810 -0.563948 4.138422 403 7302 + 7304 H 19.384494 0.416823 5.258191 403 7302 + 7305 O 1.611674 7.827775 17.729516 402 7306 7307 + 7306 H 1.683155 6.883076 17.518073 403 7305 + 7307 H 0.776664 7.948423 18.173512 403 7305 + 7308 O 9.885872 -10.367999 -15.423519 402 7309 7310 + 7309 H 9.747228 -11.080640 -16.152068 403 7308 + 7310 H 9.165955 -9.782881 -15.477159 403 7308 + 7311 O -8.001025 -8.903978 20.363588 402 7312 7313 + 7312 H -7.919331 -9.384725 21.262606 403 7311 + 7313 H -8.555002 -9.547097 19.892421 403 7311 + 7314 O -5.444250 -12.618432 -20.512332 402 7315 7316 + 7315 H -4.642289 -13.086364 -20.688100 403 7314 + 7316 H -5.443229 -12.055754 -19.736438 403 7314 + 7317 O 13.515262 -10.012095 19.152766 402 7318 7319 + 7318 H 12.845808 -9.927516 19.858658 403 7317 + 7319 H 14.340617 -9.646593 19.590648 403 7317 + 7320 O -8.356973 -7.803379 16.925718 402 7321 7322 + 7321 H -8.140830 -7.917106 15.999678 403 7320 + 7322 H -8.084091 -8.687693 17.308394 403 7320 + 7323 O 19.760910 -2.370831 2.421662 402 7324 7325 + 7324 H 20.560599 -1.857333 2.578796 403 7323 + 7325 H 19.273809 -1.863655 1.723372 403 7323 + 7326 O 16.532929 9.397948 -13.603509 402 7327 7328 + 7327 H 16.407542 10.353638 -13.545246 403 7326 + 7328 H 17.450225 9.202690 -13.801843 403 7326 + 7329 O 3.043298 -8.545676 8.964253 402 7330 7331 + 7330 H 2.418694 -7.834314 8.742863 403 7329 + 7331 H 3.163757 -8.907052 8.081541 403 7329 + 7332 O -5.314921 -13.601995 0.201579 402 7333 7334 + 7333 H -4.416708 -13.534559 -0.042940 403 7332 + 7334 H -5.417418 -14.438498 0.657175 403 7332 + 7335 O 1.416185 6.843538 -11.410595 402 7336 7337 + 7336 H 1.633970 7.742217 -11.087491 403 7335 + 7337 H 0.761793 6.459053 -10.786036 403 7335 + 7338 O 19.767922 9.421307 -8.193013 402 7339 7340 + 7339 H 19.914480 8.466041 -8.135440 403 7338 + 7340 H 19.575103 9.558308 -9.177735 403 7338 + 7341 O 26.172410 11.919029 3.610739 402 7342 7343 + 7342 H 25.535585 12.193435 4.240735 403 7341 + 7343 H 26.042272 10.983029 3.549151 403 7341 + 7344 O -21.735841 2.144400 18.211620 402 7345 7346 + 7345 H -22.104009 2.960860 18.654752 403 7344 + 7346 H -22.313927 1.460249 18.492995 403 7344 + 7347 O 1.557972 -12.790578 15.622137 402 7348 7349 + 7348 H 0.853719 -13.365055 15.935999 403 7347 + 7349 H 1.906483 -13.231160 14.910699 403 7347 + 7350 O -13.258859 4.104211 -2.315588 402 7351 7352 + 7351 H -13.608254 4.812418 -2.986967 403 7350 + 7352 H -14.087487 3.646024 -2.095452 403 7350 + 7353 O -26.307679 -0.111768 -20.714469 402 7354 7355 + 7354 H -25.812995 0.720645 -20.583269 403 7353 + 7355 H -25.528348 -0.678575 -20.909717 403 7353 + 7356 O 11.642962 12.398152 -6.461792 402 7357 7358 + 7357 H 11.596820 12.230702 -5.538685 403 7356 + 7358 H 12.552221 12.400971 -6.683261 403 7356 + 7359 O 9.805562 12.056033 0.297197 402 7360 7361 + 7360 H 10.657658 12.469311 0.654830 403 7359 + 7361 H 9.202541 11.759951 0.941289 403 7359 + 7362 O -6.826832 12.393010 9.213697 402 7363 7364 + 7363 H -6.537792 11.811004 8.506850 403 7362 + 7364 H -6.100427 12.347418 9.835231 403 7362 + 7365 O 20.133141 -17.531986 18.955618 402 7366 7367 + 7366 H 19.437169 -18.073233 18.517051 403 7365 + 7367 H 20.798807 -17.276415 18.236384 403 7365 + 7368 O 16.549382 -10.626162 16.457286 402 7369 7370 + 7369 H 16.551942 -9.717820 16.759418 403 7368 + 7370 H 16.147566 -11.023294 17.252231 403 7368 + 7371 O 1.789829 14.643494 -5.619552 402 7372 7373 + 7372 H 1.048933 14.228176 -6.039228 403 7371 + 7373 H 1.669053 14.391952 -4.707740 403 7371 + 7374 O 4.371658 -12.694698 -12.318562 402 7375 7376 + 7375 H 4.915573 -13.184619 -11.694576 403 7374 + 7376 H 4.915130 -11.958781 -12.720896 403 7374 + 7377 O -11.293082 0.237019 -19.250596 402 7378 7379 + 7378 H -11.966255 0.783547 -19.678369 403 7377 + 7379 H -11.548510 -0.704739 -19.364586 403 7377 + 7380 O -2.484806 -0.918295 -14.668621 402 7381 7382 + 7381 H -2.177091 -1.152345 -15.589201 403 7380 + 7382 H -1.695025 -0.610144 -14.221845 403 7380 + 7383 O 25.578482 -18.001184 -14.174826 402 7384 7385 + 7384 H 24.716923 -17.519582 -14.309086 403 7383 + 7385 H 26.303012 -17.438870 -14.436407 403 7383 + 7386 O 23.132217 17.040870 -8.595297 402 7387 7388 + 7387 H 23.143509 17.518773 -7.762629 403 7386 + 7388 H 22.923741 16.132690 -8.372110 403 7386 + 7389 O 2.923503 11.871856 -20.547177 402 7390 7391 + 7390 H 2.198503 11.234695 -20.236214 403 7389 + 7391 H 3.511763 11.911115 -19.844001 403 7389 + 7392 O 2.179585 4.144910 -11.877852 402 7393 7394 + 7393 H 2.151655 5.096818 -11.803012 403 7392 + 7394 H 2.729899 3.974673 -12.667805 403 7392 + 7395 O 26.669404 -11.624549 13.477594 402 7396 7397 + 7396 H 25.735733 -11.431455 13.654851 403 7395 + 7397 H 27.077849 -11.550313 14.372992 403 7395 + 7398 O 24.873075 -11.097731 10.824618 402 7399 7400 + 7399 H 25.209728 -11.897467 10.432443 403 7398 + 7400 H 25.614915 -10.682030 11.193580 403 7398 + 7401 O -1.826162 -17.791623 4.511609 402 7402 7403 + 7402 H -1.466714 -17.114337 3.985489 403 7401 + 7403 H -1.066332 -18.298254 4.813832 403 7401 + 7404 O 24.895806 4.512131 -17.916870 402 7405 7406 + 7405 H 24.133889 5.103597 -18.006070 403 7404 + 7406 H 25.725831 4.889044 -18.163865 403 7404 + 7407 O -20.306217 1.655909 -0.658591 402 7408 7409 + 7408 H -19.365596 1.457605 -0.837148 403 7407 + 7409 H -20.259907 1.991986 0.211928 403 7407 + 7410 O 13.312009 19.524936 16.387048 402 7411 7412 + 7411 H 13.933293 19.167357 15.722455 403 7410 + 7412 H 13.259660 18.816564 17.092867 403 7410 + 7413 O -6.291960 0.181353 20.409012 402 7414 7415 + 7414 H -5.886986 -0.391564 19.697954 403 7413 + 7415 H -6.191361 -0.287042 21.246927 403 7413 + 7416 O -11.925605 -14.118393 11.513337 402 7417 7418 + 7417 H -12.390021 -13.899494 10.677619 403 7416 + 7418 H -11.499213 -13.318961 11.825704 403 7416 + 7419 O 25.690900 -20.544963 -6.726643 402 7420 7421 + 7420 H 25.848636 -19.865858 -7.443635 403 7419 + 7421 H 25.541265 -21.356361 -7.237324 403 7419 + 7422 O -10.266763 4.606069 -14.148088 402 7423 7424 + 7423 H -10.666583 4.007171 -14.802051 403 7422 + 7424 H -10.592890 5.506386 -14.316808 403 7422 + 7425 O -13.700313 11.443217 -7.703372 402 7426 7427 + 7426 H -14.305805 11.566376 -8.451855 403 7425 + 7427 H -13.797593 10.519533 -7.520760 403 7425 + 7428 O 19.896960 -5.260769 2.047938 402 7429 7430 + 7429 H 20.639909 -5.673868 2.498703 403 7428 + 7430 H 19.902578 -4.275845 1.972121 403 7428 + 7431 O 27.483595 4.667361 6.350280 402 7432 7433 + 7432 H 27.612327 3.821689 6.792070 403 7431 + 7433 H 27.474096 5.241160 7.041075 403 7431 + 7434 O 16.838162 -11.125573 -1.977415 402 7435 7436 + 7435 H 17.018636 -10.652759 -1.169733 403 7434 + 7436 H 17.083147 -12.071800 -1.748280 403 7434 + 7437 O -3.825915 15.193309 16.332435 402 7438 7439 + 7438 H -3.868970 16.088775 15.893612 403 7437 + 7439 H -2.922251 14.779372 16.138541 403 7437 + 7440 O -4.999597 -20.685905 -5.935566 402 7441 7442 + 7441 H -5.618635 -20.401156 -6.580918 403 7440 + 7442 H -5.077868 -21.673790 -5.909799 403 7440 + 7443 O -20.562039 0.140160 5.669443 402 7444 7445 + 7444 H -20.686050 0.843366 6.344794 403 7443 + 7445 H -20.730893 0.582485 4.804185 403 7443 + 7446 O -6.671827 11.535978 19.876374 402 7447 7448 + 7447 H -7.261521 11.364859 20.662982 403 7446 + 7448 H -7.266511 12.144069 19.377508 403 7446 + 7449 O 4.191517 -2.479488 13.355524 402 7450 7451 + 7450 H 4.884007 -2.164404 14.019008 403 7449 + 7451 H 3.372874 -2.220309 13.814811 403 7449 + 7452 O 8.749947 16.191041 8.535964 402 7453 7454 + 7453 H 8.732297 16.863275 9.229059 403 7452 + 7454 H 8.691576 16.634682 7.644507 403 7452 + 7455 O -25.961494 14.282183 -15.383787 402 7456 7457 + 7456 H -25.985646 15.282436 -15.164995 403 7455 + 7457 H -26.833664 13.915918 -15.151600 403 7455 + 7458 O 27.385198 14.529212 8.142639 402 7459 7460 + 7459 H 26.412128 14.399556 8.083311 403 7458 + 7460 H 27.495002 15.490751 8.294493 403 7458 + 7461 O 14.126472 -14.702927 -8.987957 402 7462 7463 + 7462 H 14.925682 -14.560974 -8.448204 403 7461 + 7463 H 13.489976 -15.067821 -8.401821 403 7461 + 7464 O -23.336636 -6.121383 -20.639900 402 7465 7466 + 7465 H -22.869154 -5.535755 -20.072156 403 7464 + 7466 H -24.124908 -6.450781 -20.113919 403 7464 + 7467 O -0.774826 -13.203604 16.888646 402 7468 7469 + 7468 H -1.468020 -13.376023 16.234547 403 7467 + 7469 H -0.931871 -12.304587 17.229608 403 7467 + 7470 O 9.061125 5.283331 17.143683 402 7471 7472 + 7471 H 9.916783 5.174639 16.603587 403 7470 + 7472 H 8.778289 6.220910 17.070877 403 7470 + 7473 O -25.315423 9.781118 -15.359265 402 7474 7475 + 7474 H -24.471315 9.264358 -15.331486 403 7473 + 7475 H -25.606191 9.792640 -14.434801 403 7473 + 7476 O -10.967554 -10.738154 -9.731527 402 7477 7478 + 7477 H -11.765483 -10.936834 -9.181748 403 7476 + 7478 H -10.379375 -10.133651 -9.266538 403 7476 + 7479 O -1.488275 3.623351 -16.767913 402 7480 7481 + 7480 H -0.882657 4.371387 -16.669247 403 7479 + 7481 H -1.492403 3.254437 -17.674715 403 7479 + 7482 O 12.452312 -19.040060 3.375147 402 7483 7484 + 7483 H 12.871486 -19.871899 3.246114 403 7482 + 7484 H 11.754508 -18.893125 2.776534 403 7482 + 7485 O -15.573729 -12.221722 0.716973 402 7486 7487 + 7486 H -15.002380 -12.832434 0.254063 403 7485 + 7487 H -16.254430 -12.772029 1.034977 403 7485 + 7488 O 13.752256 -4.097413 -18.870896 402 7489 7490 + 7489 H 14.581949 -3.712772 -18.513163 403 7488 + 7490 H 13.271688 -3.261042 -18.845949 403 7488 + 7491 O -21.641111 -0.680590 0.005430 402 7492 7493 + 7492 H -21.093432 0.076279 -0.365044 403 7491 + 7493 H -21.445828 -0.814377 0.968664 403 7491 + 7494 O 15.724559 3.520455 6.328412 402 7495 7496 + 7495 H 14.921141 3.234676 6.784467 403 7494 + 7496 H 15.461693 3.698167 5.450324 403 7494 + 7497 O -27.214078 -11.147965 5.082767 402 7498 7499 + 7498 H -26.390239 -11.278816 5.572480 403 7497 + 7499 H -27.321203 -12.054005 4.683669 403 7497 + 7500 O 13.328280 7.582484 -18.567300 402 7501 7502 + 7501 H 14.185844 7.864153 -18.950423 403 7500 + 7502 H 12.732777 7.507446 -19.290185 403 7500 + 7503 O -16.683838 -4.586561 -13.916725 402 7504 7505 + 7504 H -16.820834 -4.523796 -14.842726 403 7503 + 7505 H -15.965498 -5.193692 -13.685180 403 7503 + 7506 O -19.170260 12.551147 12.092952 402 7507 7508 + 7507 H -19.387562 11.609567 12.048568 403 7506 + 7508 H -18.718827 12.726237 11.286473 403 7506 + 7509 O -2.873940 -18.817391 -0.630738 402 7510 7511 + 7510 H -2.585106 -18.870724 -1.613607 403 7509 + 7511 H -3.793192 -19.000736 -0.761036 403 7509 + 7512 O -15.440453 11.669180 16.607856 402 7513 7514 + 7513 H -15.211613 10.749409 16.748182 403 7512 + 7514 H -15.523689 11.929189 17.511524 403 7512 + 7515 O 0.676885 9.019049 7.967361 402 7516 7517 + 7516 H -0.188437 8.924038 8.296825 403 7515 + 7517 H 1.100577 8.314509 8.389075 403 7515 + 7518 O -12.658914 -13.169855 -2.443871 402 7519 7520 + 7519 H -13.329719 -13.325087 -1.824892 403 7518 + 7520 H -12.438077 -13.988972 -2.754186 403 7518 + 7521 O -16.248882 -11.627131 16.273828 402 7522 7523 + 7522 H -16.071661 -12.035171 17.149648 403 7521 + 7523 H -15.584055 -10.905357 16.247158 403 7521 + 7524 O 7.587639 18.040490 0.648325 402 7525 7526 + 7525 H 7.127313 17.621736 1.427370 403 7524 + 7526 H 8.472509 18.025945 0.938181 403 7524 + 7527 O -21.260403 -7.316165 -17.769548 402 7528 7529 + 7528 H -21.464936 -6.579095 -18.356837 403 7527 + 7529 H -21.090642 -6.945093 -16.896335 403 7527 + 7530 O 16.016635 -1.860641 -2.314369 402 7531 7532 + 7531 H 16.938184 -1.677711 -2.476393 403 7530 + 7532 H 15.526197 -1.857629 -3.158683 403 7530 + 7533 O 4.492292 -4.776655 -20.071507 402 7534 7535 + 7534 H 4.666835 -4.194018 -19.383577 403 7533 + 7535 H 5.379154 -5.033244 -20.511472 403 7533 + 7536 O -15.720931 20.128785 -10.578428 402 7537 7538 + 7537 H -15.839702 20.941641 -10.100642 403 7536 + 7538 H -16.315376 20.178519 -11.349297 403 7536 + 7539 O -26.439198 6.163682 -9.860618 402 7540 7541 + 7540 H -25.627768 6.495816 -9.484731 403 7539 + 7541 H -26.911803 6.981208 -10.036013 403 7539 + 7542 O 9.335945 11.329795 -3.722917 402 7543 7544 + 7543 H 8.644451 12.059424 -3.617751 403 7542 + 7544 H 8.888513 10.554570 -4.126032 403 7542 + 7545 O -13.380471 10.478242 6.861111 402 7546 7547 + 7546 H -13.220641 10.103750 7.786550 403 7545 + 7547 H -13.207886 11.438191 6.902907 403 7545 + 7548 O 3.128674 -13.794262 17.620598 402 7549 7550 + 7549 H 2.638158 -13.260660 17.056399 403 7548 + 7550 H 3.597573 -13.167888 18.155001 403 7548 + 7551 O -15.640110 12.239687 19.252890 402 7552 7553 + 7552 H -15.744305 13.228589 19.346365 403 7551 + 7553 H -16.382496 11.838747 19.767704 403 7551 + 7554 O 2.784908 9.116859 -10.197973 402 7555 7556 + 7555 H 3.297798 8.414513 -9.705521 403 7554 + 7556 H 3.275248 9.528201 -10.883691 403 7554 + 7557 O -7.890712 -7.603783 -17.743202 402 7558 7559 + 7558 H -7.124761 -7.008882 -17.935759 403 7557 + 7559 H -8.550851 -7.045750 -18.114982 403 7557 + 7560 O -13.699956 -6.291585 9.543158 402 7561 7562 + 7561 H -14.665087 -6.196216 9.729838 403 7560 + 7562 H -13.399326 -5.367978 9.707420 403 7560 + 7563 O 20.465588 -10.458716 3.145054 402 7564 7565 + 7564 H 20.979944 -10.701349 3.922596 403 7563 + 7565 H 19.551694 -10.315318 3.519540 403 7563 + 7566 O -21.770772 17.965042 -17.112890 402 7567 7568 + 7567 H -20.830189 18.026694 -16.817043 403 7566 + 7568 H -22.065602 18.901599 -17.079860 403 7566 + 7569 O -14.835473 -2.018047 -6.153382 402 7570 7571 + 7570 H -15.436027 -2.198495 -6.881730 403 7569 + 7571 H -15.436197 -1.848312 -5.360006 403 7569 + 7572 O 4.864928 -7.193456 16.503727 402 7573 7574 + 7573 H 4.980211 -6.246101 16.323915 403 7572 + 7574 H 5.579734 -7.640000 16.024530 403 7572 + 7575 O 19.120349 11.030815 -15.362470 402 7576 7577 + 7576 H 19.294800 10.826080 -16.279672 403 7575 + 7577 H 19.622213 10.380633 -14.881548 403 7575 + 7578 O -0.977018 13.926628 -7.123442 402 7579 7580 + 7579 H -1.852314 14.048847 -6.757564 403 7578 + 7580 H -1.008005 14.146864 -8.050474 403 7578 + 7581 O 1.836955 20.649010 5.205237 402 7582 7583 + 7582 H 1.357046 19.856623 4.900209 403 7581 + 7583 H 2.481382 20.946625 4.486330 403 7581 + 7584 O 22.248352 0.089789 14.254305 402 7585 7586 + 7585 H 21.482126 0.622149 14.431275 403 7584 + 7586 H 22.760633 -0.073685 15.065722 403 7584 + 7587 O 4.943704 7.039238 -17.178880 402 7588 7589 + 7588 H 4.132510 7.341202 -17.610714 403 7587 + 7589 H 5.316936 6.264192 -17.636046 403 7587 + 7590 O -13.513178 20.872697 -6.966661 402 7591 7592 + 7591 H -12.917889 20.159554 -6.816410 403 7590 + 7592 H -13.438901 21.399519 -6.129707 403 7590 + 7593 O -26.783745 1.737872 -10.173855 402 7594 7595 + 7594 H -27.406703 1.045834 -9.889439 403 7593 + 7595 H -26.563015 2.284868 -9.419251 403 7593 + 7596 O 16.895897 -14.537239 -4.916419 402 7597 7598 + 7597 H 17.186118 -13.833540 -5.508216 403 7596 + 7598 H 17.149098 -15.342322 -5.413605 403 7596 + 7599 O 26.817205 -3.814990 8.332532 402 7600 7601 + 7600 H 26.423093 -3.721401 9.229654 403 7599 + 7601 H 26.751966 -4.740274 8.261936 403 7599 + 7602 O 26.660512 -8.107918 -18.699113 402 7603 7604 + 7603 H 27.143708 -8.664547 -19.302869 403 7602 + 7604 H 27.318084 -7.817236 -18.086633 403 7602 + 7605 O 10.208858 -14.799716 -11.685147 402 7606 7607 + 7606 H 10.229559 -13.857528 -11.605014 403 7605 + 7607 H 10.909011 -14.996510 -12.361468 403 7605 + 7608 O -7.122161 12.606835 5.012358 402 7609 7610 + 7609 H -6.742894 13.446553 5.343573 403 7608 + 7610 H -6.707272 11.958739 5.582727 403 7608 + 7611 O -1.649859 -17.353593 -19.765333 402 7612 7613 + 7612 H -1.703196 -17.292489 -18.801764 403 7611 + 7613 H -0.740888 -17.269565 -19.956034 403 7611 + 7614 O -25.578511 10.750973 19.368175 402 7615 7616 + 7615 H -25.759953 9.955006 18.909465 403 7614 + 7616 H -26.373616 10.876703 19.816004 403 7614 + 7617 O -15.512850 14.948587 19.552015 402 7618 7619 + 7618 H -14.592416 15.278921 19.862734 403 7617 + 7619 H -15.517720 15.251241 18.670365 403 7617 + 7620 O -22.108713 15.986768 -19.097538 402 7621 7622 + 7621 H -21.973356 16.492171 -18.298729 403 7620 + 7622 H -22.275608 15.084558 -18.884443 403 7620 + 7623 O -24.432040 1.967038 -20.402572 402 7624 7625 + 7624 H -24.316057 2.005234 -19.442897 403 7623 + 7625 H -23.617246 1.596664 -20.796357 403 7623 + 7626 O 0.976021 12.002153 3.317883 402 7627 7628 + 7627 H 1.233810 12.944966 3.271665 403 7626 + 7628 H 1.053167 11.659322 4.215764 403 7626 + 7629 O -22.848328 -11.507211 20.792792 402 7630 7631 + 7630 H -22.031691 -11.288244 20.331458 403 7629 + 7631 H -23.563342 -11.121670 20.237130 403 7629 + 7632 O 5.372331 -6.390447 8.998397 402 7633 7634 + 7633 H 5.156327 -6.136745 8.105017 403 7632 + 7634 H 4.867716 -7.183706 9.243399 403 7632 + 7635 O -5.077546 13.038740 -9.712665 402 7636 7637 + 7636 H -4.384730 12.918197 -10.436683 403 7635 + 7637 H -5.739596 12.361322 -9.833579 403 7635 + 7638 O 4.313864 -17.817036 1.578679 402 7639 7640 + 7639 H 3.642179 -17.175797 1.786403 403 7638 + 7640 H 4.014882 -18.443226 0.872394 403 7638 + 7641 O -10.825600 -3.788470 12.345548 402 7642 7643 + 7642 H -11.474785 -4.350281 12.848087 403 7641 + 7643 H -11.121245 -2.913918 12.572141 403 7641 + 7644 O -10.308333 17.332588 -19.108687 402 7645 7646 + 7645 H -9.699779 18.058376 -18.760246 403 7644 + 7646 H -9.696827 16.600840 -19.450737 403 7644 + 7647 O 20.367843 11.704165 19.663819 402 7648 7649 + 7648 H 19.894726 12.360595 20.126357 403 7647 + 7649 H 20.501092 12.010854 18.743343 403 7647 + 7650 O 4.454769 15.397642 -5.721382 402 7651 7652 + 7651 H 5.096605 14.668068 -5.812036 403 7650 + 7652 H 3.560506 15.012254 -5.700523 403 7650 + 7653 O -10.186828 -2.388640 -11.736429 402 7654 7655 + 7654 H -10.325119 -2.558008 -12.705589 403 7653 + 7655 H -10.806607 -2.883931 -11.193573 403 7653 + 7656 O -24.912356 3.520925 11.318625 402 7657 7658 + 7657 H -24.410292 4.337248 11.078911 403 7656 + 7658 H -25.009199 2.856626 10.581227 403 7656 + 7659 O 25.624082 -17.044203 16.133293 402 7660 7661 + 7660 H 26.569447 -17.105418 15.881796 403 7659 + 7661 H 25.526730 -16.778186 17.038064 403 7659 + 7662 O -18.172292 -12.061346 20.656118 402 7663 7664 + 7663 H -19.064000 -11.714052 20.415716 403 7662 + 7664 H -18.318393 -12.531580 21.542312 403 7662 + 7665 O -2.771360 17.065768 -3.605776 402 7666 7667 + 7666 H -3.498372 16.467521 -3.261648 403 7665 + 7667 H -3.165333 17.613939 -4.263088 403 7665 + 7668 O 3.828793 -18.285133 -12.035298 402 7669 7670 + 7669 H 4.572657 -18.613626 -12.559285 403 7668 + 7670 H 4.121067 -17.462806 -11.547371 403 7668 + 7671 O 6.372209 19.895468 -0.828574 402 7672 7673 + 7672 H 6.671245 19.260688 -0.181419 403 7671 + 7673 H 6.498252 20.741942 -0.410853 403 7671 + 7674 O -26.077165 -2.986273 -6.579517 402 7675 7676 + 7675 H -26.530567 -3.662357 -7.045915 403 7674 + 7676 H -25.278966 -3.412687 -6.199533 403 7674 + 7677 O 1.066751 -11.604098 -7.437054 402 7678 7679 + 7678 H 0.780778 -12.103600 -8.170135 403 7677 + 7679 H 0.490797 -10.859423 -7.390052 403 7677 + 7680 O 26.435886 -19.880105 20.436273 402 7681 7682 + 7681 H 27.363986 -19.578464 20.393790 403 7680 + 7682 H 25.964716 -19.053915 20.333618 403 7680 + 7683 O 3.948373 18.634138 -19.227666 402 7684 7685 + 7684 H 4.776804 18.681442 -18.670875 403 7683 + 7685 H 3.724437 19.545742 -19.268399 403 7683 + 7686 O 6.895853 -2.593776 -14.926776 402 7687 7688 + 7687 H 6.939228 -1.872325 -14.297950 403 7686 + 7688 H 5.922138 -2.668665 -14.881269 403 7686 + 7689 O -11.002838 -0.157918 -15.377800 402 7690 7691 + 7690 H -11.039095 0.271800 -14.533222 403 7689 + 7691 H -11.858546 -0.101002 -15.791180 403 7689 + 7692 O -23.278682 -12.335400 16.986956 402 7693 7694 + 7693 H -23.969958 -13.046960 17.013455 403 7692 + 7694 H -23.739191 -11.494386 17.223424 403 7692 + 7695 O -8.733901 10.961189 15.538536 402 7696 7697 + 7696 H -9.664866 10.721280 15.448379 403 7695 + 7697 H -8.333145 10.082375 15.772687 403 7695 + 7698 O -18.407350 15.043497 -16.093194 402 7699 7700 + 7699 H -17.602548 15.511802 -15.718946 403 7698 + 7700 H -18.860502 14.688871 -15.320254 403 7698 + 7701 O -7.717846 -19.245322 6.135762 402 7702 7703 + 7702 H -8.369623 -18.587554 5.773934 403 7701 + 7703 H -8.005786 -19.439467 7.014406 403 7701 + 7704 O 27.537835 -2.244938 17.802365 402 7705 7706 + 7705 H 26.595262 -2.186775 17.618048 403 7704 + 7706 H 27.566413 -2.809518 18.555718 403 7704 + 7707 O 14.035672 -13.942494 -5.025234 402 7708 7709 + 7708 H 13.436663 -14.726681 -5.087496 403 7707 + 7709 H 14.937241 -14.361386 -5.014306 403 7707 + 7710 O -21.221588 13.030355 13.864922 402 7711 7712 + 7711 H -20.364838 12.937985 13.362956 403 7710 + 7712 H -21.556169 12.132892 13.747752 403 7710 + 7713 O 3.382602 17.477038 1.971338 402 7714 7715 + 7714 H 2.998725 16.711070 1.403757 403 7713 + 7715 H 3.440438 18.202483 1.331855 403 7713 + 7716 O -27.449290 2.763472 -5.473864 402 7717 7718 + 7717 H -26.862644 2.952928 -6.231930 403 7716 + 7718 H -28.220354 2.416823 -5.903707 403 7716 + 7719 O 21.309171 1.208177 18.719816 402 7720 7721 + 7720 H 20.908787 2.039246 18.612886 403 7719 + 7721 H 21.184556 0.863131 19.641302 403 7719 + 7722 O 11.888692 16.675087 -12.603821 402 7723 7724 + 7723 H 10.999248 16.541633 -13.021832 403 7722 + 7724 H 11.878107 16.199062 -11.723643 403 7722 + 7725 O 15.960563 -12.459489 -12.277920 402 7726 7727 + 7726 H 16.878686 -12.644050 -12.500987 403 7725 + 7727 H 16.057647 -11.602612 -11.757235 403 7725 + 7728 O -12.060427 7.034589 4.513332 402 7729 7730 + 7729 H -11.557894 7.520852 3.823017 403 7728 + 7730 H -11.343768 6.740188 5.138402 403 7728 + 7731 O -8.561873 -15.574827 18.511819 402 7732 7733 + 7732 H -8.355748 -14.726119 18.975068 403 7731 + 7733 H -9.321577 -15.327632 17.928691 403 7731 + 7734 O 26.839386 -9.977418 -11.801214 402 7735 7736 + 7735 H 27.210714 -10.886833 -12.066458 403 7734 + 7736 H 26.680237 -9.508287 -12.672668 403 7734 + 7737 O 19.487816 -4.295750 -10.653772 402 7738 7739 + 7738 H 19.155987 -5.040203 -11.186489 403 7737 + 7739 H 19.101905 -4.274245 -9.721574 403 7737 + 7740 O -2.617367 -9.196096 12.807798 402 7741 7742 + 7741 H -3.053330 -8.849761 12.003083 403 7740 + 7742 H -1.757135 -8.732443 12.734709 403 7740 + 7743 O 6.741614 9.283527 -17.879312 402 7744 7745 + 7744 H 6.380288 9.612761 -18.710343 403 7743 + 7745 H 6.169408 8.510946 -17.615438 403 7743 + 7746 O -15.244518 -2.348788 -16.411194 402 7747 7748 + 7747 H -15.286492 -3.293206 -16.627416 403 7746 + 7748 H -16.141604 -2.133344 -16.101761 403 7746 + 7749 O 24.076224 14.005333 -20.764432 402 7750 7751 + 7750 H 23.579840 13.567519 -20.086274 403 7749 + 7751 H 24.304722 13.264661 -21.387917 403 7749 + 7752 O 5.197586 -0.122428 -17.048391 402 7753 7754 + 7753 H 5.961074 0.070496 -16.498322 403 7752 + 7754 H 4.803638 0.707910 -17.262899 403 7752 + 7755 O -12.626531 20.869184 -20.635254 402 7756 7757 + 7756 H -12.565754 20.478495 -19.764243 403 7755 + 7757 H -13.248230 21.560435 -20.592028 403 7755 + 7758 O -6.742302 15.365874 -8.317692 402 7759 7760 + 7759 H -6.373557 14.699314 -8.910768 403 7758 + 7760 H -7.355781 15.918239 -8.809096 403 7758 + 7761 O -8.968953 -3.618531 16.586721 402 7762 7763 + 7762 H -8.318587 -4.203738 17.052583 403 7761 + 7763 H -8.772937 -2.703569 16.930654 403 7761 + 7764 O 4.646490 -13.425952 -20.543948 402 7765 7766 + 7765 H 5.006101 -13.053008 -19.771175 403 7764 + 7766 H 4.114028 -14.244399 -20.306406 403 7764 + 7767 O 20.560148 15.165785 18.388964 402 7768 7769 + 7768 H 20.026901 15.914780 18.133927 403 7767 + 7769 H 20.137478 14.695974 19.131845 403 7767 + 7770 O 16.253616 13.647989 17.466410 402 7771 7772 + 7771 H 16.144396 14.607506 17.611846 403 7770 + 7772 H 15.603177 13.394335 16.728326 403 7770 + 7773 O -2.493112 -10.958918 18.158226 402 7774 7775 + 7774 H -2.871350 -10.325469 17.572446 403 7773 + 7775 H -3.230138 -11.343072 18.670608 403 7773 + 7776 O 24.417011 1.731847 15.781773 402 7777 7778 + 7777 H 24.256339 1.199810 16.598463 403 7776 + 7778 H 24.103762 2.612690 16.033534 403 7776 + 7779 O 23.869641 5.093835 -10.829152 402 7780 7781 + 7780 H 23.849127 5.899360 -10.350720 403 7779 + 7781 H 24.806312 4.827153 -11.005653 403 7779 + 7782 O -25.326011 -10.985445 0.393748 402 7783 7784 + 7783 H -24.487021 -11.323998 0.018652 403 7782 + 7784 H -25.846018 -10.577330 -0.299092 403 7782 + 7785 O -22.140365 -4.015548 -19.394205 402 7786 7787 + 7786 H -21.298001 -3.731962 -19.753685 403 7785 + 7787 H -22.037014 -3.787820 -18.464135 403 7785 + 7788 O 16.480100 17.378886 -8.149325 402 7789 7790 + 7789 H 15.944629 17.865308 -8.816984 403 7788 + 7790 H 17.136048 16.933781 -8.707099 403 7788 + 7791 O 9.225758 13.395457 -14.366037 402 7792 7793 + 7792 H 8.369757 13.485099 -14.794251 403 7791 + 7793 H 9.149310 12.977217 -13.491919 403 7791 + 7794 O -11.512364 7.735604 17.233390 402 7795 7796 + 7795 H -11.580776 7.745448 18.221759 403 7794 + 7796 H -10.572713 7.856344 17.057877 403 7794 + 7797 O 22.313965 -17.567699 -18.743216 402 7798 7799 + 7798 H 22.795472 -18.390700 -18.665650 403 7797 + 7799 H 21.527641 -17.771604 -19.283408 403 7797 + 7800 O 26.008630 -8.991349 -9.190478 402 7801 7802 + 7801 H 26.251546 -9.200527 -10.105321 403 7800 + 7802 H 25.207812 -9.493737 -9.000776 403 7800 + 7803 O 16.930474 19.046264 7.447647 402 7804 7805 + 7804 H 16.385483 19.298108 8.210284 403 7803 + 7805 H 17.081495 19.851182 6.876771 403 7803 + 7806 O -6.878192 14.458044 -14.342832 402 7807 7808 + 7807 H -6.947724 15.178650 -14.986529 403 7806 + 7808 H -6.902494 14.876539 -13.459345 403 7806 + 7809 O -2.603745 -0.170130 11.118461 402 7810 7811 + 7810 H -2.603735 0.193993 10.245898 403 7809 + 7811 H -2.301286 0.557857 11.700540 403 7809 + 7812 O -18.658918 6.935889 12.709416 402 7813 7814 + 7813 H -18.611105 7.903442 12.826990 403 7812 + 7814 H -17.731206 6.682204 12.672567 403 7812 + 7815 O 8.242150 20.321564 16.671943 402 7816 7817 + 7816 H 8.085884 19.395160 16.403784 403 7815 + 7817 H 9.204603 20.443804 16.719883 403 7815 + 7818 O -26.194647 -1.598660 12.827976 402 7819 7820 + 7819 H -25.470850 -1.539447 12.228660 403 7818 + 7820 H -26.434617 -2.532329 12.905279 403 7818 + 7821 O 18.147255 11.834318 16.939503 402 7822 7823 + 7822 H 17.684791 12.638752 17.229443 403 7821 + 7823 H 19.094703 11.992223 16.922098 403 7821 + 7824 O -24.103113 17.414200 -20.406032 402 7825 7826 + 7825 H -24.841847 16.822155 -20.721607 403 7824 + 7826 H -23.364705 16.873068 -20.183752 403 7824 + 7827 O -20.188758 19.419367 -3.947439 402 7828 7829 + 7828 H -20.092108 20.138589 -4.627770 403 7827 + 7829 H -20.779520 18.760391 -4.305720 403 7827 + 7830 O -19.169152 16.892293 -12.706791 402 7831 7832 + 7831 H -18.376967 16.525250 -12.263419 403 7830 + 7832 H -19.451828 16.244073 -13.317784 403 7830 + 7833 O 3.042793 -9.624584 6.339287 402 7834 7835 + 7834 H 2.126469 -9.764000 6.059404 403 7833 + 7835 H 3.422607 -10.448883 6.082030 403 7833 + 7836 O 26.796575 -0.250362 10.146355 402 7837 7838 + 7837 H 27.695465 -0.487351 9.790163 403 7836 + 7838 H 26.991766 0.015930 11.058370 403 7836 + 7839 O -2.724018 -17.347993 -17.041468 402 7840 7841 + 7840 H -3.685391 -17.148462 -17.004347 403 7839 + 7841 H -2.333214 -17.040061 -16.217705 403 7839 + 7842 O 22.693834 -19.258880 -8.334918 402 7843 7844 + 7843 H 23.207274 -18.747223 -7.672504 403 7842 + 7844 H 21.922700 -19.482635 -7.787257 403 7842 + 7845 O 10.650819 14.245326 -8.863815 402 7846 7847 + 7846 H 10.590380 14.958254 -9.492462 403 7845 + 7847 H 9.797431 14.052470 -8.521894 403 7845 + 7848 O 21.896317 10.846424 11.520743 402 7849 7850 + 7849 H 22.820423 10.614982 11.723752 403 7848 + 7850 H 21.512259 10.848333 12.397036 403 7848 + 7851 O -16.629808 6.024934 -16.061930 402 7852 7853 + 7852 H -16.979035 6.163556 -15.154311 403 7851 + 7853 H -16.556800 6.853702 -16.565081 403 7851 + 7854 O -24.056464 -15.267357 -3.334116 402 7855 7856 + 7855 H -24.017471 -15.426759 -2.411717 403 7854 + 7856 H -23.826595 -16.112409 -3.791556 403 7854 + 7857 O -24.814205 14.617559 -6.421721 402 7858 7859 + 7858 H -24.613019 15.462145 -6.916680 403 7857 + 7859 H -25.784459 14.689331 -6.455648 403 7857 + 7860 O 12.539335 -4.690091 16.952299 402 7861 7862 + 7861 H 12.874872 -3.959104 17.433778 403 7860 + 7862 H 13.165313 -5.396450 16.984519 403 7860 + 7863 O 27.426473 -20.349285 -4.187459 402 7864 7865 + 7864 H 26.932613 -20.185019 -4.988935 403 7863 + 7865 H 27.020619 -19.915963 -3.444392 403 7863 + 7866 O -25.378069 18.390923 12.676602 402 7867 7868 + 7867 H -25.468295 18.108442 13.617931 403 7866 + 7868 H -26.284264 18.454249 12.373374 403 7866 + 7869 O 2.358488 15.655904 0.172343 402 7870 7871 + 7870 H 1.576275 15.538047 -0.330180 403 7869 + 7871 H 2.949284 15.115348 -0.279388 403 7869 + 7872 O 17.823860 -16.181961 4.219054 402 7873 7874 + 7873 H 16.871832 -16.285669 3.895196 403 7872 + 7874 H 18.296855 -16.171292 3.367102 403 7872 + 7875 O -13.185175 11.185524 20.273552 402 7876 7877 + 7876 H -12.491020 11.326572 19.606343 403 7875 + 7877 H -14.008783 11.327741 19.799749 403 7875 + 7878 O -16.946375 18.382248 -17.880917 402 7879 7880 + 7879 H -16.601871 19.114714 -17.373712 403 7878 + 7880 H -17.112525 18.719683 -18.756566 403 7878 + 7881 O 4.139489 13.924517 -8.158999 402 7882 7883 + 7882 H 3.276763 13.674016 -7.871220 403 7881 + 7883 H 4.619548 13.009700 -8.222873 403 7881 + 7884 O 19.195530 19.194186 -15.410073 402 7885 7886 + 7885 H 19.530087 20.044690 -15.698710 403 7884 + 7886 H 18.880211 18.717599 -16.173654 403 7884 + 7887 O 22.465366 -15.697985 -16.572314 402 7888 7889 + 7888 H 22.341005 -16.447983 -17.175221 403 7887 + 7889 H 23.268415 -15.298896 -16.787665 403 7887 + 7890 O -6.168779 -9.840021 -9.350190 402 7891 7892 + 7891 H -6.138060 -10.776075 -9.519650 403 7890 + 7892 H -5.375773 -9.424169 -9.650695 403 7890 + 7893 O 25.209173 18.017697 -14.898072 402 7894 7895 + 7894 H 24.521605 17.467415 -14.490123 403 7893 + 7895 H 25.669461 17.420196 -15.513375 403 7893 + 7896 O 1.750289 -0.354167 -16.972701 402 7897 7898 + 7897 H 1.941430 -1.107141 -17.603779 403 7896 + 7898 H 1.332140 0.330238 -17.528621 403 7896 + 7899 O 18.682749 11.765475 10.852294 402 7900 7901 + 7900 H 19.563556 11.904202 10.494828 403 7899 + 7901 H 18.677947 10.845188 11.223074 403 7899 + 7902 O -9.368425 16.562190 4.853452 402 7903 7904 + 7903 H -8.407375 16.292116 4.842479 403 7902 + 7904 H -9.332928 17.502581 4.563723 403 7902 + 7905 O -14.320728 -5.516222 -17.892457 402 7906 7907 + 7906 H -14.106677 -5.147397 -18.800379 403 7905 + 7907 H -14.225038 -6.471192 -17.943054 403 7905 + 7908 O -22.779663 -5.587037 4.961004 402 7909 7910 + 7909 H -23.387774 -5.905882 4.279957 403 7908 + 7910 H -22.003636 -6.116854 4.731429 403 7908 + 7911 O 1.608693 14.675487 10.806060 402 7912 7913 + 7912 H 2.333564 15.322059 10.910925 403 7911 + 7913 H 1.191042 14.647480 11.723121 403 7911 + 7914 O -19.989851 14.272748 -13.831000 402 7915 7916 + 7915 H -20.108765 14.145345 -12.856725 403 7914 + 7916 H -20.810178 14.265544 -14.251075 403 7914 + 7917 O -0.277500 6.116052 -20.054497 402 7918 7919 + 7918 H -1.205482 6.025573 -19.750342 403 7917 + 7919 H 0.030270 6.890733 -19.590961 403 7917 + 7920 O -23.218686 16.925049 -14.531729 402 7921 7922 + 7921 H -24.154801 17.137589 -14.620012 403 7920 + 7922 H -22.798436 17.177619 -15.342960 403 7920 + 7923 O 14.465041 -13.890297 11.092988 402 7924 7925 + 7924 H 14.125737 -13.087596 11.450092 403 7923 + 7925 H 14.769204 -13.729760 10.198115 403 7923 + 7926 O -19.342535 19.484499 18.315509 402 7927 7928 + 7927 H -18.817282 19.354539 19.111327 403 7926 + 7928 H -19.942353 18.726732 18.320837 403 7926 + 7929 O 0.909574 12.732606 15.451247 402 7930 7931 + 7930 H 0.713888 11.749814 15.284439 403 7929 + 7931 H 1.425345 12.740199 16.283139 403 7929 + 7932 O -2.274926 14.829696 20.985211 402 7933 7934 + 7933 H -2.781123 13.962453 20.790809 403 7932 + 7934 H -2.630126 15.421882 20.359114 403 7932 + 7935 O 7.507399 6.793027 13.609399 402 7936 7937 + 7936 H 7.518937 7.728154 13.813229 403 7935 + 7937 H 8.443553 6.424691 13.587889 403 7935 + 7938 O 12.870660 -12.764019 -10.964166 402 7939 7940 + 7939 H 12.942835 -13.465015 -11.598871 403 7938 + 7940 H 13.227628 -13.197338 -10.244586 403 7938 + 7941 O 8.913179 -11.919018 -6.239675 402 7942 7943 + 7942 H 8.887002 -11.850316 -5.252925 403 7941 + 7943 H 8.813455 -11.004941 -6.499380 403 7941 + 7944 O -25.746417 7.206326 5.578919 402 7945 7946 + 7945 H -25.082293 6.620904 5.823246 403 7944 + 7946 H -26.564541 6.922453 6.051858 403 7944 + 7947 O 25.894755 9.257899 3.861774 402 7948 7949 + 7948 H 26.648604 8.789353 3.465470 403 7947 + 7949 H 25.145952 8.756940 3.475241 403 7947 + 7950 O -8.830905 19.535286 -18.058852 402 7951 7952 + 7951 H -7.932809 19.419232 -17.567730 403 7950 + 7952 H -8.446850 19.854198 -18.903385 403 7950 + 7953 O 18.592621 -6.587479 -13.125998 402 7954 7955 + 7954 H 18.627063 -5.766281 -13.617980 403 7953 + 7955 H 19.549944 -6.934441 -13.170231 403 7953 + 7956 O -27.003747 -19.268722 -9.708049 402 7957 7958 + 7957 H -26.900925 -18.931745 -10.609127 403 7956 + 7958 H -27.848600 -18.948692 -9.403186 403 7956 + 7959 O 25.990256 18.432601 -19.230300 402 7960 7961 + 7960 H 26.786890 18.827306 -19.540837 403 7959 + 7961 H 25.720829 18.921009 -18.426769 403 7959 + 7962 O -23.820277 -18.817979 -12.740742 402 7963 7964 + 7963 H -23.782285 -19.769046 -12.956748 403 7962 + 7964 H -23.248364 -18.334977 -13.329239 403 7962 + 7965 O -18.359691 4.931419 0.480080 402 7966 7967 + 7966 H -18.326292 5.822977 0.895967 403 7965 + 7967 H -17.534355 4.919940 -0.130658 403 7965 + 7968 O -18.507249 20.994985 10.044481 402 7969 7970 + 7969 H -18.547987 20.135365 9.607738 403 7968 + 7970 H -19.101082 20.989892 10.808237 403 7968 + 7971 O -4.383167 -16.727404 18.388451 402 7972 7973 + 7972 H -5.073507 -17.158665 17.848255 403 7971 + 7973 H -3.547429 -16.962110 18.031186 403 7971 + 7974 O -4.804252 -2.255440 12.424858 402 7975 7976 + 7975 H -5.246469 -3.100345 12.658891 403 7974 + 7976 H -3.913941 -2.453866 12.205563 403 7974 + 7977 O -24.450781 12.411164 4.813077 402 7978 7979 + 7978 H -24.979534 11.582140 4.901976 403 7977 + 7979 H -24.028938 12.289668 3.990280 403 7977 + 7980 O -26.039273 15.478503 -20.033643 402 7981 7982 + 7981 H -25.787380 14.593225 -19.599455 403 7980 + 7982 H -26.775794 15.819420 -19.491089 403 7980 + 7983 O 14.062056 9.563642 16.993740 402 7984 7985 + 7984 H 14.763770 8.911350 17.143673 403 7983 + 7985 H 14.500104 10.412012 17.077299 403 7983 + 7986 O 4.484184 -11.730676 11.850201 402 7987 7988 + 7987 H 4.881439 -12.103947 12.684819 403 7986 + 7988 H 3.547835 -11.668873 12.049225 403 7986 + 7989 O -14.097503 8.062860 -18.256877 402 7990 7991 + 7990 H -14.097091 8.286015 -19.217701 403 7989 + 7991 H -14.272348 7.101844 -18.168430 403 7989 + 7992 O -1.242617 -6.859800 16.709128 402 7993 7994 + 7993 H -1.538903 -6.069642 17.158826 403 7992 + 7994 H -0.956774 -6.520222 15.820973 403 7992 + 7995 O -1.281101 10.186382 20.363478 402 7996 7997 + 7996 H -1.124991 9.953584 19.434999 403 7995 + 7997 H -1.916024 10.917360 20.415283 403 7995 + 7998 O 4.583247 -14.837260 7.792526 402 7999 8000 + 7999 H 5.277242 -15.516956 7.802532 403 7998 + 8000 H 3.716772 -15.158571 7.921129 403 7998 + 8001 O -4.482585 -19.369183 -19.767924 402 8002 8003 + 8002 H -4.741173 -18.669761 -19.147665 403 8001 + 8003 H -4.193943 -19.053555 -20.619737 403 8001 + 8004 O 7.047318 -14.707276 -20.284385 402 8005 8006 + 8005 H 6.703500 -15.207330 -19.488017 403 8004 + 8006 H 6.190142 -14.503563 -20.700524 403 8004 + 8007 O 23.833142 -6.861157 16.589067 402 8008 8009 + 8008 H 24.695476 -7.170817 16.950692 403 8007 + 8009 H 23.677150 -7.301955 15.784807 403 8007 + 8010 O 5.995679 -17.998909 3.914141 402 8011 8012 + 8011 H 5.476318 -17.882781 3.080567 403 8010 + 8012 H 5.412579 -18.346872 4.640099 403 8010 + 8013 O -16.261535 -16.837503 19.128385 402 8014 8015 + 8014 H -16.159495 -17.582113 18.531735 403 8013 + 8015 H -16.037295 -17.072210 20.047591 403 8013 + 8016 O 12.975391 18.290335 10.617581 402 8017 8018 + 8017 H 12.118949 18.283115 10.175431 403 8016 + 8018 H 12.802601 18.580055 11.511186 403 8016 + 8019 O -16.943334 -0.673380 -20.801827 402 8020 8021 + 8020 H -17.817924 -1.087446 -20.715945 403 8019 + 8021 H -17.115465 0.133442 -21.270654 403 8019 + 8022 O 6.976699 -19.049773 17.844693 402 8023 8024 + 8023 H 7.570702 -18.339339 17.660197 403 8022 + 8024 H 7.315559 -19.860252 17.427987 403 8022 + 8025 O 24.109467 19.393222 12.331621 402 8026 8027 + 8026 H 23.874527 19.733950 13.195341 403 8025 + 8027 H 23.847585 18.486492 12.389872 403 8025 + 8028 O -10.766788 -13.469242 4.827464 402 8029 8030 + 8029 H -10.709694 -13.795601 3.910452 403 8028 + 8030 H -10.845380 -12.510608 4.689270 403 8028 + 8031 O 23.311349 8.299149 -20.488106 402 8032 8033 + 8032 H 22.936005 9.229209 -20.435353 403 8031 + 8033 H 23.101181 8.056904 -21.396526 403 8031 + 8034 O 14.346382 2.187727 18.536242 402 8035 8036 + 8035 H 14.267850 1.244178 18.689768 403 8034 + 8036 H 15.244469 2.406046 18.304739 403 8034 + 8037 O -26.947566 -9.971921 -7.791553 402 8038 8039 + 8038 H -26.523003 -9.588995 -7.018587 403 8037 + 8039 H -27.719947 -9.398867 -7.926452 403 8037 + 8040 O -1.645004 -17.217466 18.281848 402 8041 8042 + 8041 H -1.503441 -17.212547 17.328466 403 8040 + 8042 H -1.259441 -16.407871 18.526419 403 8040 + 8043 O -18.185068 -13.481465 -18.963605 402 8044 8045 + 8044 H -18.306998 -12.962840 -18.154768 403 8043 + 8045 H -18.826126 -14.192063 -18.983318 403 8043 + 8046 O 21.894032 -11.323972 -14.426640 402 8047 8048 + 8047 H 22.165764 -10.897898 -13.607124 403 8046 + 8048 H 22.549926 -11.213429 -15.092175 403 8046 + 8049 O 10.286552 3.282899 -14.672865 402 8050 8051 + 8050 H 10.156644 2.736482 -13.881860 403 8049 + 8051 H 9.503828 3.794923 -14.925645 403 8049 + 8052 O -17.275465 -16.899995 -12.204316 402 8053 8054 + 8053 H -16.650047 -17.347498 -12.847925 403 8052 + 8054 H -17.728716 -17.694142 -11.839955 403 8052 + 8055 O 9.132713 -17.465568 14.475104 402 8056 8057 + 8056 H 9.109121 -16.931937 13.716053 403 8055 + 8057 H 8.685477 -18.260615 14.298118 403 8055 + 8058 O -2.219003 -10.437316 7.385585 402 8059 8060 + 8059 H -2.683869 -9.726981 6.932036 403 8058 + 8060 H -2.863656 -10.910261 7.899378 403 8058 + 8061 O 21.328627 5.452241 -5.411722 402 8062 8063 + 8062 H 20.702591 5.402774 -4.696060 403 8061 + 8063 H 21.847512 4.616832 -5.258353 403 8061 + 8064 O 25.174339 -4.700786 4.319189 402 8065 8066 + 8065 H 25.475426 -5.192515 3.516499 403 8064 + 8066 H 24.849082 -5.290270 5.019481 403 8064 + 8067 O -20.973509 17.475850 18.235841 402 8068 8069 + 8068 H -20.795645 16.959839 19.077904 403 8067 + 8069 H -21.937194 17.741268 18.405829 403 8067 + 8070 O -17.032214 -4.404070 -16.615581 402 8071 8072 + 8071 H -18.027750 -4.237947 -16.713048 403 8070 + 8072 H -16.825738 -5.153522 -17.221012 403 8070 + 8073 O 5.077355 4.864838 15.841740 402 8074 8075 + 8074 H 5.888380 4.293000 15.916342 403 8073 + 8075 H 5.502771 5.719564 15.999661 403 8073 + 8076 O 14.150746 7.193364 7.768856 402 8077 8078 + 8077 H 13.512887 7.556242 8.342946 403 8076 + 8078 H 13.719519 6.964481 6.933299 403 8076 + 8079 O 24.979967 10.864144 -3.827107 402 8080 8081 + 8080 H 25.315666 11.790605 -3.820018 403 8079 + 8081 H 24.586117 10.647324 -4.635764 403 8079 + 8082 O -19.307013 7.977617 -19.097895 402 8083 8084 + 8083 H -18.730894 8.713079 -18.873103 403 8082 + 8084 H -19.574094 8.132279 -20.016040 403 8082 + 8085 O 24.806727 -12.761480 -19.492468 402 8086 8087 + 8086 H 24.884669 -13.553250 -18.933552 403 8085 + 8087 H 23.868023 -12.741257 -19.679606 403 8085 + 8088 O -16.494024 -10.263681 -3.455262 402 8089 8090 + 8089 H -16.433900 -9.520847 -4.087773 403 8088 + 8090 H -16.512097 -9.942519 -2.552121 403 8088 + 8091 O 7.239107 -8.678420 15.402099 402 8092 8093 + 8092 H 8.128327 -8.620090 15.837696 403 8091 + 8093 H 7.413730 -9.358400 14.729775 403 8091 + 8094 O -11.637039 -18.299602 1.445919 402 8095 8096 + 8095 H -11.805502 -17.472273 0.974361 403 8094 + 8096 H -10.835652 -18.063314 1.950128 403 8094 + 8097 O 3.539913 -9.008378 14.869684 402 8098 8099 + 8098 H 3.690725 -8.667083 13.987735 403 8097 + 8099 H 3.786240 -8.275061 15.438308 403 8097 + 8100 O 25.309639 -20.139973 8.261630 402 8101 8102 + 8101 H 26.025004 -20.789387 8.243372 403 8100 + 8102 H 24.785538 -20.229959 9.088332 403 8100 + 8103 O -11.167618 15.368263 17.768795 402 8104 8105 + 8104 H -11.447760 15.042536 16.890680 403 8103 + 8105 H -10.221576 15.243374 17.719247 403 8103 + 8106 O 15.783799 16.252451 16.657327 402 8107 8108 + 8107 H 16.469650 16.826129 16.279349 403 8106 + 8108 H 15.146657 16.166099 16.010457 403 8106 + 8109 O -23.087822 12.851874 11.524125 402 8110 8111 + 8110 H -22.550515 13.272517 12.247361 403 8109 + 8111 H -23.433828 13.646077 11.045696 403 8109 + 8112 O 18.224787 5.336233 10.181216 402 8113 8114 + 8113 H 17.768669 5.758936 9.423686 403 8112 + 8114 H 17.527118 5.295554 10.828797 403 8112 + 8115 O 23.091715 -2.832106 10.928215 402 8116 8117 + 8116 H 23.963022 -3.221214 10.847174 403 8115 + 8117 H 23.111421 -1.957098 10.500452 403 8115 + 8118 O -8.122293 -8.153763 8.762475 402 8119 8120 + 8119 H -8.486311 -7.377176 8.275878 403 8118 + 8120 H -7.842547 -7.967759 9.693098 403 8118 + 8121 O -23.746981 -1.978340 20.222446 402 8122 8123 + 8122 H -24.119623 -2.610408 19.587105 403 8121 + 8123 H -22.788269 -2.052555 20.075719 403 8121 + 8124 O 15.889034 -8.818090 19.786354 402 8125 8126 + 8125 H 16.162821 -8.087882 19.189549 403 8124 + 8126 H 16.517604 -9.567302 19.583898 403 8124 + 8127 O -22.434542 -1.993577 2.665229 402 8128 8129 + 8128 H -21.639169 -2.320398 3.125908 403 8127 + 8129 H -22.887302 -1.544538 3.368374 403 8127 + 8130 O -4.294135 12.198286 3.905187 402 8131 8132 + 8131 H -3.524217 12.481373 3.400532 403 8130 + 8132 H -4.358032 12.831366 4.583192 403 8130 + 8133 O -10.287802 2.763656 12.120543 402 8134 8135 + 8134 H -10.140580 1.873404 11.826731 403 8133 + 8135 H -10.262187 2.731368 13.100818 403 8133 + 8136 O 11.514142 11.933521 -10.265166 402 8137 8138 + 8137 H 11.257715 12.740478 -9.772518 403 8136 + 8138 H 11.449563 11.209135 -9.611780 403 8136 + 8139 O 4.752686 10.041816 10.494911 402 8140 8141 + 8140 H 5.000099 10.228340 11.405783 403 8139 + 8141 H 4.465587 10.901799 10.118351 403 8139 + 8142 O 17.099352 -16.900118 20.580015 402 8143 8144 + 8143 H 16.248341 -17.056394 20.914403 403 8142 + 8144 H 16.964732 -16.230792 19.853524 403 8142 + 8145 O -6.880763 4.754709 14.803663 402 8146 8147 + 8146 H -7.780049 5.017298 14.837120 403 8145 + 8147 H -6.602000 5.380408 14.109963 403 8145 + 8148 O 18.852257 3.117416 3.416315 402 8149 8150 + 8149 H 18.466519 2.248205 3.599368 403 8148 + 8150 H 19.770424 2.988919 3.600584 403 8148 + 8151 O -19.565302 -15.452338 -12.857316 402 8152 8153 + 8152 H -19.465174 -14.703294 -13.434992 403 8151 + 8153 H -18.713185 -15.861077 -12.849765 403 8151 + 8154 O -22.600437 -10.691469 12.850297 402 8155 8156 + 8155 H -23.397550 -10.659087 13.302216 403 8154 + 8156 H -22.787116 -11.067370 12.012734 403 8154 + 8157 O -21.982415 -13.573385 -4.311729 402 8158 8159 + 8158 H -22.884778 -13.924822 -4.053153 403 8157 + 8159 H -21.591210 -13.340585 -3.436663 403 8157 + 8160 O -9.482768 -17.119153 10.316888 402 8161 8162 + 8161 H -10.089752 -16.593034 9.704444 403 8160 + 8162 H -9.402425 -17.912940 9.854825 403 8160 + 8163 O 14.779023 -10.205617 3.169184 402 8164 8165 + 8164 H 14.033719 -9.624095 2.903870 403 8163 + 8165 H 14.431082 -10.650018 3.996000 403 8163 + 8166 O -23.065785 7.688851 4.302863 402 8167 8168 + 8167 H -23.519497 6.846326 4.179947 403 8166 + 8168 H -23.396856 8.243234 3.642471 403 8166 + 8169 O -12.420110 17.313613 -9.713155 402 8170 8171 + 8170 H -13.364634 17.232909 -9.649724 403 8169 + 8171 H -12.198343 18.200726 -10.087577 403 8169 + 8172 O 13.807063 -18.735375 -18.358481 402 8173 8174 + 8173 H 13.518261 -18.146104 -17.665040 403 8172 + 8174 H 14.609291 -19.207101 -18.003404 403 8172 + 8175 O 10.712591 7.098327 3.970951 402 8176 8177 + 8176 H 10.424496 6.939336 4.829144 403 8175 + 8177 H 10.486897 6.231102 3.501449 403 8175 + 8178 O -26.193278 8.679696 17.901485 402 8179 8180 + 8179 H -25.410504 8.357458 17.457879 403 8178 + 8180 H -26.819464 8.901614 17.137834 403 8178 + 8181 O 19.451507 -12.567707 -15.280479 402 8182 8183 + 8182 H 19.003766 -12.254527 -14.428024 403 8181 + 8183 H 20.294592 -12.135913 -15.254851 403 8181 + 8184 O -14.332854 -0.923507 14.572189 402 8185 8186 + 8185 H -14.044747 -0.194105 14.037975 403 8184 + 8186 H -13.492568 -1.193300 14.988120 403 8184 + 8187 O -8.730522 14.085678 -10.180676 402 8188 8189 + 8188 H -8.524068 13.138626 -10.211460 403 8187 + 8189 H -9.480763 14.191583 -10.748692 403 8187 + 8190 O -18.278878 -5.590157 8.386336 402 8191 8192 + 8191 H -18.405152 -4.662040 8.661744 403 8190 + 8192 H -17.563780 -5.717750 9.039776 403 8190 + 8193 O -24.210906 -9.471833 -3.828648 402 8194 8195 + 8194 H -23.595084 -9.970587 -4.330527 403 8193 + 8195 H -23.577826 -8.951405 -3.327851 403 8193 + 8196 O -7.110604 8.838398 10.174602 402 8197 8198 + 8197 H -7.782545 9.119070 9.563121 403 8196 + 8198 H -6.874836 7.936950 10.110612 403 8196 + 8199 O 24.419141 17.000522 -10.922840 402 8200 8201 + 8200 H 23.664703 16.933938 -11.553390 403 8199 + 8201 H 24.021846 17.152778 -10.052143 403 8199 + 8202 O -14.488243 5.098469 4.479912 402 8203 8204 + 8203 H -13.709956 5.650481 4.473177 403 8202 + 8204 H -14.910202 5.058380 3.581039 403 8202 + 8205 O -2.415807 -13.812743 6.907700 402 8206 8207 + 8206 H -2.596718 -13.309899 6.111317 403 8205 + 8207 H -3.251745 -14.327682 7.109165 403 8205 + 8208 O -18.926033 -9.523396 -18.297588 402 8209 8210 + 8209 H -18.539154 -9.705366 -19.167443 403 8208 + 8210 H -19.196583 -8.616444 -18.314206 403 8208 + 8211 O 23.648770 -10.033565 -19.143545 402 8212 8213 + 8212 H 23.763359 -9.374241 -19.822180 403 8211 + 8213 H 24.359914 -10.609348 -19.397407 403 8211 + 8214 O 0.735457 -17.444252 -0.196869 402 8215 8216 + 8215 H 1.204966 -17.103235 -0.982724 403 8214 + 8216 H -0.166461 -17.675326 -0.501142 403 8214 + 8217 O 15.977053 8.980217 19.819118 402 8218 8219 + 8218 H 15.510910 8.262919 19.411773 403 8217 + 8219 H 15.638831 9.774710 19.469638 403 8217 + 8220 O -21.818391 12.562887 20.032627 402 8221 8222 + 8221 H -22.085628 11.618258 19.842948 403 8220 + 8222 H -20.827992 12.718524 19.975012 403 8220 + 8223 O 7.039712 -16.964990 -15.541675 402 8224 8225 + 8224 H 6.809451 -17.534371 -14.799854 403 8223 + 8225 H 7.846558 -16.584905 -15.213738 403 8223 + 8226 O -10.516103 -19.359216 -4.984483 402 8227 8228 + 8227 H -11.487322 -19.499249 -4.976576 403 8226 + 8228 H -10.316797 -19.130113 -5.876399 403 8226 + 8229 O -15.712544 -18.195821 -16.791463 402 8230 8231 + 8230 H -15.386725 -17.379305 -16.972966 403 8229 + 8231 H -16.234052 -18.450302 -17.577749 403 8229 + 8232 O 20.375630 2.207122 -4.920313 402 8233 8234 + 8233 H 20.216775 1.456591 -4.343459 403 8232 + 8234 H 20.280207 1.853389 -5.797632 403 8232 + 8235 O 22.857055 19.552693 3.665905 402 8236 8237 + 8236 H 22.878248 19.783393 4.649190 403 8235 + 8237 H 23.742572 19.802123 3.384761 403 8235 + 8238 O -23.291098 12.571857 -7.317143 402 8239 8240 + 8239 H -23.912608 13.233941 -6.880268 403 8238 + 8240 H -22.652186 12.332429 -6.543330 403 8238 + 8241 O 12.984606 10.221427 -16.808099 402 8242 8243 + 8242 H 13.667678 9.959368 -16.244780 403 8241 + 8243 H 12.511584 9.401797 -16.883576 403 8241 + 8244 O 27.270245 0.587979 13.208753 402 8245 8246 + 8245 H 27.702404 -0.278797 13.294250 403 8244 + 8246 H 26.279511 0.464606 13.258979 403 8244 + 8247 O 5.657499 -16.976293 13.990530 402 8248 8249 + 8248 H 4.705984 -16.954734 13.883042 403 8247 + 8249 H 5.909722 -16.502798 14.791441 403 8247 + 8250 O 22.979947 17.951763 0.527007 402 8251 8252 + 8251 H 22.428004 18.639190 0.176667 403 8250 + 8252 H 22.281623 17.341478 0.914453 403 8250 + 8253 O -21.891524 -16.491873 5.462047 402 8254 8255 + 8254 H -21.611111 -15.606060 5.550776 403 8253 + 8255 H -22.025511 -16.701806 4.529568 403 8253 + 8256 O 8.528721 7.946876 17.483315 402 8257 8258 + 8257 H 9.390982 8.385502 17.311853 403 8256 + 8258 H 8.485801 7.948173 18.426233 403 8256 + 8259 O 26.823691 0.686378 2.887481 402 8260 8261 + 8260 H 26.841167 0.391628 3.805678 403 8259 + 8261 H 26.597454 1.662650 2.917193 403 8259 + 8262 O -4.950286 -7.194323 15.626699 402 8263 8264 + 8263 H -4.352839 -6.657887 15.072055 403 8262 + 8264 H -5.857741 -7.272638 15.219003 403 8262 + 8265 O -8.714977 5.000352 11.128210 402 8266 8267 + 8266 H -9.170865 4.207326 11.391243 403 8265 + 8267 H -8.026665 4.716136 10.523111 403 8265 + 8268 O -21.206733 -3.279994 -6.524932 402 8269 8270 + 8269 H -20.929590 -2.947470 -5.608742 403 8268 + 8270 H -21.369929 -2.564467 -7.124044 403 8268 + 8271 O -24.169876 -16.066494 -0.699927 402 8272 8273 + 8272 H -23.893194 -16.983386 -0.501792 403 8271 + 8273 H -23.818535 -15.566437 0.016995 403 8271 + 8274 O -4.762418 0.978128 -17.450230 402 8275 8276 + 8275 H -5.459419 0.534407 -17.851461 403 8274 + 8276 H -3.876584 0.532188 -17.586085 403 8274 + 8277 O -23.690384 0.720873 19.030161 402 8278 8279 + 8278 H -24.529537 0.743437 18.583662 403 8277 + 8279 H -23.655688 -0.011267 19.593259 403 8277 + 8280 O -15.912159 -12.362138 19.142289 402 8281 8282 + 8281 H -16.860673 -12.328378 19.455109 403 8280 + 8282 H -15.543971 -13.259386 19.298591 403 8280 + 8283 O 21.658993 17.599149 -16.014662 402 8284 8285 + 8284 H 22.041785 18.520354 -15.943036 403 8283 + 8285 H 20.778035 17.749200 -16.427622 403 8283 + 8286 O -19.912308 -13.107035 -14.484614 402 8287 8288 + 8287 H -19.659870 -12.430860 -13.832450 403 8286 + 8288 H -19.896529 -12.695904 -15.325705 403 8286 + 8289 O -24.276277 -16.465070 11.658834 402 8290 8291 + 8290 H -24.414709 -16.008322 12.561598 403 8289 + 8291 H -24.456920 -15.764788 11.022016 403 8289 + 8292 O 7.338121 15.134359 12.353797 402 8293 8294 + 8293 H 6.756929 14.359360 12.209000 403 8292 + 8294 H 7.312954 15.621960 11.560650 403 8292 + 8295 O 16.833359 -15.091185 7.049718 402 8296 8297 + 8296 H 17.575828 -15.201998 7.598156 403 8295 + 8297 H 17.181929 -14.913423 6.159696 403 8295 + 8298 O -25.459827 -8.831619 -10.909942 402 8299 8300 + 8299 H -26.346699 -9.154571 -11.164077 403 8298 + 8300 H -25.113612 -9.635356 -10.548749 403 8298 + 8301 O 14.104756 2.118788 -11.000106 402 8302 8303 + 8302 H 14.145828 1.958779 -9.996196 403 8301 + 8303 H 13.664160 1.315915 -11.343904 403 8301 + 8304 O 15.657145 -19.646810 2.896166 402 8305 8306 + 8305 H 16.434824 -20.115913 3.051182 403 8304 + 8306 H 15.028606 -20.220332 2.452201 403 8304 + 8307 O 23.725885 -12.794695 -0.945499 402 8308 8309 + 8308 H 23.281780 -11.890719 -0.926868 403 8307 + 8309 H 24.708749 -12.621299 -0.988388 403 8307 + 8310 O -16.865263 14.164216 13.710722 402 8311 8312 + 8311 H -17.362193 13.380801 13.838272 403 8310 + 8312 H -16.087062 13.922374 13.209541 403 8310 + 8313 O -19.739666 -15.403180 15.520974 402 8314 8315 + 8314 H -20.455057 -15.397351 14.881774 403 8313 + 8315 H -20.082522 -14.871806 16.282279 403 8313 + 8316 O 19.096837 -7.172079 16.486018 402 8317 8318 + 8317 H 19.407501 -6.257692 16.370379 403 8316 + 8318 H 19.040095 -7.459208 15.607247 403 8316 + 8319 O 18.172332 -12.158590 -6.201699 402 8320 8321 + 8320 H 18.304057 -11.335714 -6.732706 403 8319 + 8321 H 19.035089 -12.338188 -5.764950 403 8319 + 8322 O -0.868698 -19.642469 -16.996885 402 8323 8324 + 8323 H -1.363468 -20.113317 -17.713302 403 8322 + 8324 H -1.471726 -19.010491 -16.662422 403 8322 + 8325 O -24.645397 10.341459 -7.907386 402 8326 8327 + 8326 H -25.403222 10.434913 -7.336084 403 8325 + 8327 H -24.138877 11.164300 -7.816681 403 8325 + 8328 O -16.672238 -8.013464 18.598945 402 8329 8330 + 8329 H -16.066967 -8.743970 18.706313 403 8328 + 8330 H -16.176282 -7.259661 18.335226 403 8328 + 8331 O 22.487322 14.165266 -7.478753 402 8332 8333 + 8332 H 22.557098 13.462620 -8.195467 403 8331 + 8333 H 23.077183 13.896514 -6.804199 403 8331 + 8334 O -16.969008 0.617904 2.364611 402 8335 8336 + 8335 H -17.366120 1.196458 3.012496 403 8334 + 8336 H -16.204897 0.132723 2.713670 403 8334 + 8337 O -16.105014 -0.776954 10.291984 402 8338 8339 + 8338 H -16.257341 0.223589 10.333435 403 8337 + 8339 H -16.822249 -1.143779 10.739482 403 8337 + 8340 O -1.572980 -19.983373 -2.947973 402 8341 8342 + 8341 H -1.992560 -20.034455 -3.807433 403 8340 + 8342 H -0.620010 -19.746082 -3.116100 403 8340 + 8343 O -14.996679 12.712532 -5.614114 402 8344 8345 + 8344 H -15.916609 12.454215 -5.655277 403 8343 + 8345 H -14.599913 12.087283 -6.181656 403 8343 + 8346 O -6.550042 17.243085 -1.311911 402 8347 8348 + 8347 H -7.370137 17.795578 -1.470109 403 8346 + 8348 H -6.675338 16.814239 -0.435288 403 8346 + 8349 O -22.961585 9.343900 -1.894881 402 8350 8351 + 8350 H -22.135413 9.413165 -2.387021 403 8349 + 8351 H -23.019360 8.393337 -1.628379 403 8349 + 8352 O -23.240008 -19.417092 6.368497 402 8353 8354 + 8353 H -23.612098 -20.201035 6.825569 403 8352 + 8354 H -23.684109 -18.690648 6.877699 403 8352 + 8355 O -3.975590 2.585287 -20.330975 402 8356 8357 + 8356 H -3.555653 1.727030 -20.090182 403 8355 + 8357 H -3.232879 3.201768 -20.459323 403 8355 + 8358 O 13.624748 -19.863473 12.144241 402 8359 8360 + 8359 H 14.457772 -19.530528 12.546517 403 8358 + 8360 H 12.915028 -19.260602 12.383266 403 8358 + 8361 O 23.620886 -17.871879 14.645268 402 8362 8363 + 8362 H 24.200914 -17.421417 15.259794 403 8361 + 8363 H 23.549736 -17.298378 13.830439 403 8361 + 8364 O 9.321358 4.851563 -10.671349 402 8365 8366 + 8365 H 8.417643 4.825903 -10.980879 403 8364 + 8366 H 9.236659 5.389642 -9.880988 403 8364 + 8367 O 16.676932 -15.595371 18.042582 402 8368 8369 + 8368 H 15.776328 -15.312249 17.740520 403 8367 + 8369 H 17.268778 -14.856833 17.976717 403 8367 + 8370 O 5.120016 13.517889 11.545409 402 8371 8372 + 8371 H 4.343182 13.415911 12.098245 403 8370 + 8372 H 4.693345 13.853732 10.680472 403 8370 + 8373 O -25.377039 -18.256471 8.076220 402 8374 8375 + 8374 H -25.781276 -18.544454 8.897977 403 8373 + 8375 H -25.633977 -17.323858 7.972468 403 8373 + 8376 O 0.809058 7.564416 -14.066874 402 8377 8378 + 8377 H 0.916059 7.331613 -13.143223 403 8376 + 8378 H 1.470333 8.274989 -14.200531 403 8376 + 8379 O 15.418267 9.781452 0.490529 402 8380 8381 + 8380 H 16.087047 9.430117 -0.107289 403 8379 + 8381 H 15.469266 9.208927 1.264230 403 8379 + 8382 O 18.819099 0.059487 -7.791298 402 8383 8384 + 8383 H 18.409799 -0.334456 -8.599701 403 8382 + 8384 H 18.505418 0.975155 -7.815461 403 8382 + 8385 O 18.734857 -11.129665 -12.743525 402 8386 8387 + 8386 H 19.553404 -11.223386 -12.120138 403 8385 + 8387 H 18.518443 -10.240054 -12.855533 403 8385 + 8388 O -6.542631 16.490309 -5.774007 402 8389 8390 + 8389 H -7.424909 16.908246 -5.691889 403 8388 + 8390 H -6.518994 16.127379 -6.676862 403 8388 + 8391 O -11.192140 0.472205 -12.639446 402 8392 8393 + 8392 H -12.103697 0.267919 -12.529950 403 8391 + 8393 H -10.710800 -0.374282 -12.557572 403 8391 + 8394 O 16.720488 13.886958 -20.533060 402 8395 8396 + 8395 H 16.205223 14.702224 -20.376437 403 8394 + 8396 H 16.691127 13.403715 -19.702754 403 8394 + 8397 O 17.388334 13.435587 -15.657568 402 8398 8399 + 8398 H 18.130270 13.582226 -16.327461 403 8397 + 8399 H 17.639406 12.621568 -15.195169 403 8397 + 8400 O -6.834253 10.232886 -18.214238 402 8401 8402 + 8401 H -6.903061 10.582756 -17.312839 403 8400 + 8402 H -7.065760 10.977380 -18.753726 403 8400 + 8403 O -26.724908 17.912645 17.886470 402 8404 8405 + 8404 H -25.957218 18.458136 17.628812 403 8403 + 8405 H -26.362765 17.099535 18.218344 403 8403 + 8406 O -0.903403 -3.732795 -18.221524 402 8407 8408 + 8407 H 0.015845 -3.986413 -18.434069 403 8406 + 8408 H -1.449749 -4.292278 -18.787390 403 8406 + 8409 O 8.478846 18.397280 11.407292 402 8410 8411 + 8410 H 7.633351 18.651942 11.041557 403 8409 + 8411 H 9.129265 18.582960 10.779627 403 8409 + 8412 O -9.044898 12.879599 11.037060 402 8413 8414 + 8413 H -8.299458 12.613036 10.480728 403 8412 + 8414 H -9.785562 12.774996 10.383091 403 8412 + 8415 O 16.212680 8.794036 14.029672 402 8416 8417 + 8416 H 15.473945 9.288728 13.836685 403 8415 + 8417 H 17.028607 9.276518 14.011973 403 8415 + 8418 O -12.268552 13.361223 -20.521861 402 8419 8420 + 8419 H -13.186409 13.158881 -20.579852 403 8418 + 8420 H -12.306685 14.297827 -20.782380 403 8418 + 8421 O 21.001802 -1.484392 16.467423 402 8422 8423 + 8422 H 20.737187 -1.861020 17.327615 403 8421 + 8423 H 21.860569 -1.911455 16.193850 403 8421 + 8424 O -9.356304 11.431280 -8.974418 402 8425 8426 + 8425 H -8.659737 10.769575 -8.653703 403 8424 + 8426 H -9.803431 11.675976 -8.182315 403 8424 + 8427 O 26.948445 8.871461 -17.613543 402 8428 8429 + 8428 H 27.531052 9.681414 -17.576254 403 8427 + 8429 H 27.482335 8.261182 -17.042391 403 8427 + 8430 O 18.976966 2.434133 -12.543728 402 8431 8432 + 8431 H 18.194377 2.424795 -11.982928 403 8430 + 8432 H 19.117316 3.368724 -12.808991 403 8430 + 8433 O 8.245403 -12.742057 19.723005 402 8434 8435 + 8434 H 8.144484 -13.022949 20.662655 403 8433 + 8435 H 7.837153 -13.446042 19.196869 403 8433 + 8436 O 9.039756 -7.597109 18.653269 402 8437 8438 + 8437 H 8.770812 -7.616934 19.576989 403 8436 + 8438 H 9.066589 -6.664479 18.418706 403 8436 + 8439 O 10.189217 11.926636 11.235547 402 8440 8441 + 8440 H 10.233257 12.873995 11.065027 403 8439 + 8441 H 9.236322 11.798256 11.121031 403 8439 + 8442 O -19.235380 -20.224186 -5.743147 402 8443 8444 + 8443 H -19.963520 -19.550478 -5.766714 403 8442 + 8444 H -18.597575 -19.892671 -5.077870 403 8442 + 8445 O 17.081164 12.504780 -5.519702 402 8446 8447 + 8446 H 17.317528 12.830762 -4.628825 403 8445 + 8447 H 17.566228 11.707478 -5.694496 403 8445 + 8448 O -17.833354 13.022736 -7.625662 402 8449 8450 + 8449 H -18.435075 12.266236 -7.562794 403 8448 + 8450 H -17.596760 13.126821 -6.753333 403 8448 + 8451 O -16.003848 -12.359888 13.230149 402 8452 8453 + 8452 H -16.195567 -13.201470 12.841886 403 8451 + 8453 H -16.339851 -12.416796 14.117412 403 8451 + 8454 O 0.176516 -12.560501 -12.425472 402 8455 8456 + 8455 H 0.737394 -13.294947 -12.707192 403 8454 + 8456 H -0.008554 -11.988851 -13.210535 403 8454 + 8457 O 15.945838 0.256833 12.759642 402 8458 8459 + 8458 H 15.315992 0.578271 12.079867 403 8457 + 8459 H 15.303877 -0.130234 13.393857 403 8457 + 8460 O 3.991270 11.948196 8.788506 402 8461 8462 + 8461 H 4.354131 11.617913 7.978688 403 8460 + 8462 H 3.989725 12.878797 8.755522 403 8460 + 8463 O 24.041021 -18.227784 19.978317 402 8464 8465 + 8464 H 23.613150 -19.023367 19.715938 403 8463 + 8465 H 23.421760 -17.634320 20.391706 403 8463 + 8466 O 4.480569 2.293232 -17.929461 402 8467 8468 + 8467 H 4.737918 2.408019 -18.806644 403 8466 + 8468 H 3.697109 2.859289 -17.719771 403 8466 + 8469 O -21.893430 -14.247042 -8.071389 402 8470 8471 + 8470 H -21.621325 -13.340615 -8.179140 403 8469 + 8471 H -21.245096 -14.771492 -7.611926 403 8469 + 8472 O 11.391170 -20.197067 6.087190 402 8473 8474 + 8473 H 12.332346 -20.225253 6.056925 403 8472 + 8474 H 11.169435 -19.741912 5.268989 403 8472 + 8475 O -17.767521 13.536365 -18.283934 402 8476 8477 + 8476 H -17.676219 14.086222 -17.468766 403 8475 + 8477 H -17.016627 12.978563 -18.394451 403 8475 + 8478 O 5.005032 -20.873389 -8.545316 402 8479 8480 + 8479 H 4.212566 -20.486316 -8.983260 403 8478 + 8480 H 4.690972 -21.402526 -7.849785 403 8478 + 8481 O 18.199775 -4.330757 -14.972084 402 8482 8483 + 8482 H 17.789625 -3.483346 -14.772916 403 8481 + 8483 H 18.849294 -4.135351 -15.681645 403 8481 + 8484 O 19.744670 16.153747 4.684702 402 8485 8486 + 8485 H 18.926975 15.872879 5.113981 403 8484 + 8486 H 20.486481 15.836577 5.222155 403 8484 + 8487 O -0.915970 -9.397508 15.585411 402 8488 8489 + 8488 H -0.105843 -9.703483 16.010408 403 8487 + 8489 H -1.285330 -8.812368 16.200287 403 8487 + 8490 O -23.858596 3.816844 -5.177897 402 8491 8492 + 8491 H -23.879687 4.029482 -4.237763 403 8490 + 8492 H -24.276504 2.954820 -5.342696 403 8490 + 8493 O 11.838596 14.359137 5.947499 402 8494 8495 + 8494 H 11.923450 13.438110 5.725008 403 8493 + 8495 H 12.426438 14.419837 6.789373 403 8493 + 8496 O -24.516087 -8.212903 6.467548 402 8497 8498 + 8497 H -24.905939 -8.825058 7.092971 403 8496 + 8498 H -23.896260 -8.737352 6.010203 403 8496 + 8499 O 12.794509 0.536645 -20.243875 402 8500 8501 + 8500 H 12.046024 0.975194 -20.739130 403 8499 + 8501 H 12.750658 0.998686 -19.404096 403 8499 + 8502 O -2.221545 7.221132 -15.714309 402 8503 8504 + 8503 H -1.564134 7.922819 -15.440249 403 8502 + 8504 H -1.907716 6.786282 -16.499729 403 8502 + 8505 O -15.262103 -1.025135 3.744497 402 8506 8507 + 8506 H -15.665604 -1.870757 3.765630 403 8505 + 8507 H -15.328619 -0.606155 4.583614 403 8505 + 8508 O 20.108494 -9.991193 -19.911625 402 8509 8510 + 8509 H 19.428700 -9.825766 -19.213627 403 8508 + 8510 H 20.361712 -9.133136 -20.249113 403 8508 + 8511 O 12.867409 -6.904802 4.443594 402 8512 8513 + 8512 H 12.264306 -6.203776 4.409753 403 8511 + 8513 H 13.784027 -6.565705 4.350727 403 8511 + 8514 O 24.058876 -8.248822 -17.051222 402 8515 8516 + 8515 H 23.730319 -9.008822 -17.519701 403 8514 + 8516 H 24.878618 -8.026208 -17.519719 403 8514 + 8517 O -14.847363 -1.001783 -19.170682 402 8518 8519 + 8518 H -15.449801 -0.826718 -19.858698 403 8517 + 8519 H -15.320403 -1.330455 -18.387373 403 8517 + 8520 O 15.553192 2.814264 -3.465226 402 8521 8522 + 8521 H 14.896744 3.481739 -3.135135 403 8520 + 8522 H 16.160657 3.336721 -3.991437 403 8520 + 8523 O -13.974002 9.185648 16.956055 402 8524 8525 + 8524 H -13.130305 8.696408 16.805351 403 8523 + 8525 H -14.376866 8.733537 17.688722 403 8523 + 8526 O -11.797740 -0.516894 9.586967 402 8527 8528 + 8527 H -12.628798 -0.925501 9.242559 403 8526 + 8528 H -11.646717 0.185675 8.970795 403 8526 + 8529 O 24.903028 -3.994226 -11.118622 402 8530 8531 + 8530 H 23.952025 -4.106045 -10.736954 403 8529 + 8531 H 24.790476 -3.484811 -11.918719 403 8529 + 8532 O 2.220549 5.328975 16.431794 402 8533 8534 + 8533 H 1.808604 4.568086 16.851941 403 8532 + 8534 H 3.174924 5.179737 16.323538 403 8532 + 8535 O 1.396616 14.937103 19.138615 402 8536 8537 + 8536 H 0.558182 14.600636 18.844822 403 8535 + 8537 H 1.257435 14.884393 20.102246 403 8535 + 8538 O -20.671636 -15.366474 -18.208204 402 8539 8540 + 8539 H -21.380399 -15.277369 -18.859413 403 8538 + 8540 H -20.736983 -16.181001 -17.742657 403 8538 + 8541 O -13.058044 -20.095582 -4.362430 402 8542 8543 + 8542 H -13.024712 -20.612656 -3.543798 403 8541 + 8543 H -13.691481 -19.389144 -4.075579 403 8541 + 8544 O -15.561123 -4.237765 12.636329 402 8545 8546 + 8545 H -16.268647 -3.833291 13.167415 403 8544 + 8546 H -15.110937 -3.419743 12.299589 403 8544 + 8547 O -24.759181 -6.035582 2.884287 402 8548 8549 + 8548 H -25.250513 -6.831996 2.887098 403 8547 + 8549 H -25.305365 -5.369041 2.551951 403 8547 + 8550 O -4.620853 12.299627 11.037908 402 8551 8552 + 8551 H -4.440765 13.138122 11.409774 403 8550 + 8552 H -4.916886 11.692935 11.716163 403 8550 + 8553 O -16.569703 1.526861 -7.254759 402 8554 8555 + 8554 H -16.695783 1.936301 -8.074606 403 8553 + 8555 H -16.882141 0.632206 -7.402201 403 8553 + 8556 O 23.467888 -9.654261 -12.695108 402 8557 8558 + 8557 H 24.029597 -9.067666 -13.167615 403 8556 + 8558 H 23.123232 -9.217050 -11.833851 403 8556 + 8559 O -18.429010 -3.061156 8.894173 402 8560 8561 + 8560 H -19.027972 -2.389846 8.642550 403 8559 + 8561 H -18.106797 -2.785618 9.787642 403 8559 + 8562 O -19.107978 15.849121 -9.475466 402 8563 8564 + 8563 H -18.864733 15.428418 -8.655322 403 8562 + 8564 H -18.505127 16.629956 -9.591908 403 8562 + 8565 O 22.274682 -20.084251 -0.325198 402 8566 8567 + 8566 H 22.135094 -19.096797 -0.356152 403 8565 + 8567 H 23.083213 -20.126631 -0.830959 403 8565 + 8568 O 24.369325 -3.216706 -4.897640 402 8569 8570 + 8569 H 25.222404 -2.719894 -4.895318 403 8568 + 8570 H 24.445157 -3.895914 -4.229474 403 8568 + 8571 O -9.139981 -19.842644 16.043544 402 8572 8573 + 8572 H -8.820691 -19.672535 15.122253 403 8571 + 8573 H -9.672340 -20.660357 15.944536 403 8571 + 8574 O -20.896241 -15.764905 -2.307185 402 8575 8576 + 8575 H -21.812479 -15.705631 -2.446120 403 8574 + 8576 H -20.844603 -15.784793 -1.327016 403 8574 + 8577 O 7.223156 -5.748983 -18.629737 402 8578 8579 + 8578 H 7.206095 -4.844227 -18.946828 403 8577 + 8579 H 7.989785 -5.796585 -18.164482 403 8577 + 8580 O -25.843140 -1.143611 9.149078 402 8581 8582 + 8581 H -25.886005 -1.657786 8.289135 403 8580 + 8582 H -25.272098 -1.801443 9.596520 403 8580 + 8583 O -25.617505 11.234770 1.302402 402 8584 8585 + 8584 H -26.519698 11.382080 0.891273 403 8583 + 8585 H -25.709717 11.496799 2.260967 403 8583 + 8586 O -24.008718 3.700426 14.077463 402 8587 8588 + 8587 H -23.636744 2.818441 14.397144 403 8586 + 8588 H -24.193959 3.715212 13.098008 403 8586 + 8589 O -25.288161 15.287096 -3.633466 402 8590 8591 + 8590 H -24.701801 15.181375 -2.917528 403 8589 + 8591 H -24.884059 15.980496 -4.222265 403 8589 + 8592 O -18.371976 0.316233 -12.753606 402 8593 8594 + 8593 H -17.540257 0.805382 -12.677195 403 8592 + 8594 H -18.928928 0.935156 -13.269213 403 8592 + 8595 O -7.333443 0.117823 -18.660950 402 8596 8597 + 8596 H -8.021021 0.414744 -18.077567 403 8595 + 8597 H -7.588161 -0.774648 -18.860400 403 8595 + 8598 O 7.916046 -4.737118 -11.962175 402 8599 8600 + 8599 H 7.823803 -4.591176 -10.961540 403 8598 + 8600 H 8.487079 -3.962811 -12.242330 403 8598 + 8601 O -16.065017 -17.683748 12.637430 402 8602 8603 + 8602 H -17.011987 -17.735296 12.722608 403 8601 + 8603 H -15.831448 -18.384474 11.953837 403 8601 + 8604 O 21.305339 -15.655490 -5.124093 402 8605 8606 + 8605 H 20.807407 -16.186834 -5.710639 403 8604 + 8606 H 21.624819 -16.214868 -4.447516 403 8604 + 8607 O -26.764181 -18.581640 -16.921151 402 8608 8609 + 8608 H -26.740653 -17.883931 -16.251171 403 8607 + 8609 H -25.889831 -19.016845 -16.852743 403 8607 + 8610 O -16.578359 -2.340901 14.589648 402 8611 8612 + 8611 H -16.492161 -3.040832 15.326073 403 8610 + 8612 H -15.697628 -1.820257 14.616293 403 8610 + 8613 O 26.043166 5.997514 -3.795215 402 8614 8615 + 8614 H 26.451990 6.864435 -3.803447 403 8613 + 8615 H 26.795850 5.513156 -3.370169 403 8613 + 8616 O -2.866251 17.249672 -19.402655 402 8617 8618 + 8617 H -2.050135 17.665045 -19.652864 403 8616 + 8618 H -2.832242 16.313071 -19.542218 403 8616 + 8619 O -15.459807 -11.710100 -10.460216 402 8620 8621 + 8620 H -14.969300 -11.366276 -9.661631 403 8619 + 8621 H -16.276955 -12.017208 -9.984012 403 8619 + 8622 O 19.650264 6.930828 12.762298 402 8623 8624 + 8623 H 19.873188 6.462285 13.595929 403 8622 + 8624 H 20.303044 6.550090 12.177619 403 8622 + 8625 O -22.570365 -4.412836 -1.811273 402 8626 8627 + 8626 H -22.171357 -5.263031 -1.838077 403 8625 + 8627 H -22.826216 -4.391044 -0.929643 403 8625 + 8628 O -15.225393 0.344956 6.093949 402 8629 8630 + 8629 H -14.897061 1.256657 6.050627 403 8628 + 8630 H -14.862108 -0.118094 6.882677 403 8628 + 8631 O -26.214592 10.149434 -12.755279 402 8632 8633 + 8632 H -27.155901 10.181440 -12.954282 403 8631 + 8633 H -26.080437 9.913123 -11.832638 403 8631 + 8634 O -26.639137 -20.836220 10.642324 402 8635 8636 + 8635 H -26.244776 -19.942202 10.604043 403 8634 + 8636 H -26.010374 -21.363114 10.100802 403 8634 + 8637 O 27.068918 -13.224704 20.865450 402 8638 8639 + 8638 H 27.744233 -12.679284 21.316162 403 8637 + 8639 H 26.232445 -12.945570 21.191563 403 8637 + 8640 O -15.301597 13.975513 -8.460131 402 8641 8642 + 8641 H -14.952706 13.782668 -7.567357 403 8640 + 8642 H -16.244257 13.821878 -8.381549 403 8640 + 8643 O 25.467875 11.658105 -7.593959 402 8644 8645 + 8644 H 24.761290 11.160502 -7.120317 403 8643 + 8645 H 25.002961 12.057880 -8.288551 403 8643 + 8646 O -27.479869 -4.262964 -20.483737 402 8647 8648 + 8647 H -26.752473 -4.746654 -20.858210 403 8646 + 8648 H -27.165915 -3.756567 -19.782830 403 8646 + 8649 O -24.406173 20.048905 -13.265390 402 8650 8651 + 8650 H -23.845919 19.394517 -12.782711 403 8649 + 8651 H -25.326791 19.952777 -13.266139 403 8649 + 8652 O -12.606740 1.855396 14.924299 402 8653 8654 + 8653 H -13.099296 2.292250 15.633985 403 8652 + 8654 H -13.213129 1.841828 14.213081 403 8652 + 8655 O 12.163259 12.537713 19.532478 402 8656 8657 + 8656 H 12.952113 12.023699 19.336851 403 8655 + 8657 H 11.421932 11.885251 19.451751 403 8655 + 8658 O 19.216013 1.204159 16.354062 402 8659 8660 + 8659 H 19.693651 0.628292 16.987922 403 8658 + 8660 H 19.788924 1.982359 16.259421 403 8658 + 8661 O 9.476954 16.143883 -14.222672 402 8662 8663 + 8662 H 9.874109 15.966920 -15.122506 403 8661 + 8663 H 9.278436 15.281894 -13.908079 403 8661 + 8664 O -14.534233 -15.722743 -17.125213 402 8665 8666 + 8665 H -14.612818 -15.234699 -16.271855 403 8664 + 8666 H -14.914996 -15.225762 -17.899753 403 8664 + 8667 O -7.315791 17.649326 18.027047 402 8668 8669 + 8668 H -6.781097 18.032306 18.752166 403 8667 + 8669 H -8.151176 18.220094 17.921736 403 8667 + 8670 O -18.382710 -16.629801 4.193883 402 8671 8672 + 8671 H -18.385951 -16.521263 5.149432 403 8670 + 8672 H -17.627253 -16.147937 3.769420 403 8670 + 8673 O -15.417927 -6.534956 -12.241821 402 8674 8675 + 8674 H -15.990818 -7.277530 -12.157190 403 8673 + 8675 H -15.651097 -5.969923 -11.493776 403 8673 + 8676 O 0.402862 14.629930 13.340607 402 8677 8678 + 8677 H -0.252964 15.247709 13.638832 403 8676 + 8678 H 0.540834 14.019125 14.040061 403 8676 + 8679 O 12.212673 -14.561562 8.432466 402 8680 8681 + 8680 H 12.964986 -15.158798 8.469829 403 8679 + 8681 H 12.315635 -13.749340 8.974910 403 8679 + 8682 O -18.091351 14.816669 -20.791191 402 8683 8684 + 8683 H -17.950349 14.394028 -19.955312 403 8682 + 8684 H -17.259160 15.337091 -20.997461 403 8682 + 8685 O 20.846407 4.941141 -20.805564 402 8686 8687 + 8686 H 20.364445 5.609240 -20.314152 403 8685 + 8687 H 21.773006 5.036677 -20.468448 403 8685 + 8688 O -18.235581 1.799447 7.616936 402 8689 8690 + 8689 H -18.663035 2.668602 7.871183 403 8688 + 8690 H -18.147248 1.507995 8.534548 403 8688 + 8691 O 12.243946 -10.407747 -4.453069 402 8692 8693 + 8692 H 12.758610 -10.750408 -5.173538 403 8691 + 8693 H 11.391861 -10.887258 -4.514732 403 8691 + 8694 O -15.999205 -0.324038 16.881023 402 8695 8696 + 8695 H -15.685432 -0.202706 15.976630 403 8694 + 8696 H -15.623326 0.405687 17.366937 403 8694 + 8697 O -23.099614 -14.642217 -19.649766 402 8698 8699 + 8698 H -23.777759 -15.309775 -19.518530 403 8697 + 8699 H -23.241127 -14.411915 -20.620505 403 8697 + 8700 O -12.249488 9.185541 -16.320990 402 8701 8702 + 8701 H -12.902804 8.826914 -16.950148 403 8700 + 8702 H -11.588894 9.548457 -16.894605 403 8700 + 8703 O -4.051701 -13.736377 -16.555628 402 8704 8705 + 8704 H -4.494654 -14.354729 -17.129699 403 8703 + 8705 H -4.462835 -13.910768 -15.684946 403 8703 + 8706 O -11.801200 19.657830 -10.999540 402 8707 8708 + 8707 H -10.902720 19.828996 -11.011831 403 8706 + 8708 H -12.193533 20.466103 -10.567549 403 8706 + 8709 O -24.325618 14.045672 -1.110263 402 8710 8711 + 8710 H -24.668600 14.350444 -0.200830 403 8709 + 8711 H -24.816092 13.231043 -1.195474 403 8709 + 8712 O 20.913056 15.489658 -18.886527 402 8713 8714 + 8713 H 20.368015 16.190531 -18.479805 403 8712 + 8714 H 21.821778 15.751011 -18.640831 403 8712 + 8715 O -20.772862 0.764056 -6.084683 402 8716 8717 + 8716 H -20.333324 1.468628 -5.568275 403 8715 + 8717 H -20.870557 -0.044044 -5.434493 403 8715 + 8718 O -16.073764 -5.000219 -5.989733 402 8719 8720 + 8719 H -15.211568 -4.748827 -5.581555 403 8718 + 8720 H -16.376788 -5.851245 -5.640415 403 8718 + 8721 O -9.856355 -16.695376 -19.135619 402 8722 8723 + 8722 H -10.833867 -16.815665 -19.193496 403 8721 + 8723 H -9.591699 -17.153724 -19.905312 403 8721 + 8724 O -14.392982 0.813400 -5.967904 402 8725 8726 + 8725 H -14.439076 -0.104057 -5.900368 403 8724 + 8726 H -15.047260 1.134714 -6.628678 403 8724 + 8727 O 11.045455 -13.563452 -6.886523 402 8728 8729 + 8728 H 10.981894 -14.173292 -6.136333 403 8727 + 8729 H 10.392197 -12.867802 -6.742279 403 8727 + 8730 O 20.205100 13.593403 -6.053417 402 8731 8732 + 8731 H 19.481313 14.001651 -6.432278 403 8730 + 8732 H 20.986779 14.039356 -6.342708 403 8730 + 8733 O -15.365488 5.137757 1.769971 402 8734 8735 + 8734 H -16.164843 4.770892 1.413857 403 8733 + 8735 H -14.688240 4.932112 1.136328 403 8733 + 8736 O -24.720205 -11.036422 -9.472540 402 8737 8738 + 8737 H -25.299911 -10.766165 -8.734947 403 8736 + 8738 H -25.200381 -11.736926 -9.906125 403 8736 + 8739 O 14.559792 11.008849 -19.039727 402 8740 8741 + 8740 H 15.234376 11.619514 -18.598604 403 8739 + 8741 H 13.848001 10.777673 -18.398174 403 8739 + 8742 O 20.737940 13.944347 3.008812 402 8743 8744 + 8743 H 19.926090 13.665780 2.507060 403 8742 + 8744 H 20.524403 14.681916 3.550067 403 8742 + 8745 O -13.687080 4.284684 12.620334 402 8746 8747 + 8746 H -14.374801 3.638577 12.764178 403 8745 + 8747 H -13.341649 4.114854 11.765071 403 8745 + 8748 O 10.858099 -17.177182 -20.193932 402 8749 8750 + 8749 H 10.006770 -17.050221 -20.711055 403 8748 + 8750 H 11.163899 -17.997677 -20.596267 403 8748 + 8751 O -1.413844 20.882523 -7.532723 402 8752 8753 + 8752 H -0.481522 20.795022 -7.591494 403 8751 + 8753 H -1.734791 20.061230 -7.123891 403 8751 + 8754 O 14.883760 4.844985 -11.460983 402 8755 8756 + 8755 H 14.857826 5.007527 -12.430076 403 8754 + 8756 H 14.543696 3.941245 -11.329620 403 8754 + 8757 O -6.076326 -4.794057 13.123230 402 8758 8759 + 8758 H -7.063204 -4.795068 13.194896 403 8757 + 8759 H -5.787599 -5.455376 13.703743 403 8757 + 8760 O 26.801734 19.306820 7.537896 402 8761 8762 + 8761 H 27.324481 18.524252 7.345834 403 8760 + 8762 H 27.305309 20.057747 7.249205 403 8760 + 8763 O 17.631040 11.938297 -2.819567 402 8764 8765 + 8764 H 18.494147 11.630708 -2.989743 403 8763 + 8765 H 17.500906 12.097849 -1.861896 403 8763 + 8766 O -5.066723 14.593124 8.613540 402 8767 8768 + 8767 H -5.776044 13.928470 8.604036 403 8766 + 8768 H -5.472521 15.379622 8.936421 403 8766 + 8769 O -22.625793 -6.943329 -10.402222 402 8770 8771 + 8770 H -22.918006 -7.487802 -11.106371 403 8769 + 8771 H -22.525718 -6.063678 -10.788262 403 8769 + 8772 O 11.828624 -19.683428 -20.603919 402 8773 8774 + 8773 H 12.217112 -20.243126 -21.346224 403 8772 + 8774 H 12.385880 -19.784195 -19.860322 403 8772 + 8775 O -21.139138 9.961065 13.641562 402 8776 8777 + 8776 H -21.977740 9.505083 13.402813 403 8775 + 8777 H -20.669934 9.781538 12.788303 403 8775 + 8778 O 25.519216 -5.515401 1.511029 402 8779 8780 + 8779 H 26.084211 -5.177738 0.810141 403 8778 + 8780 H 24.693318 -5.003524 1.409607 403 8778 + 8781 O 26.272080 10.541058 9.764091 402 8782 8783 + 8782 H 25.609606 11.193003 9.426754 403 8781 + 8783 H 25.839012 9.942262 10.435364 403 8781 + 8784 O 25.016001 0.794303 -1.014649 402 8785 8786 + 8785 H 25.368203 0.342397 -1.801633 403 8784 + 8786 H 25.407512 1.692440 -0.976171 403 8784 + 8787 O -8.746565 3.936264 -17.089748 402 8788 8789 + 8788 H -8.606611 4.042084 -18.035704 403 8787 + 8789 H -8.750589 2.966468 -16.991948 403 8787 + 8790 O 21.588920 13.603723 -12.704304 402 8791 8792 + 8791 H 21.601929 14.305164 -12.022119 403 8790 + 8792 H 21.312576 14.081953 -13.484692 403 8790 + 8793 O -18.216349 -3.529717 0.360926 402 8794 8795 + 8794 H -18.540051 -2.874458 0.978203 403 8793 + 8795 H -18.963370 -4.161327 0.221890 403 8793 + 8796 O 19.308604 17.633776 -17.848331 402 8797 8798 + 8797 H 18.426310 17.372206 -17.746813 403 8796 + 8798 H 19.313729 18.351135 -18.545042 403 8796 + 8799 O 23.180289 12.694539 3.506974 402 8800 8801 + 8800 H 22.252060 12.962086 3.303073 403 8799 + 8801 H 23.366253 11.863114 3.057800 403 8799 + 8802 O -17.100932 8.883526 -6.444854 402 8803 8804 + 8803 H -16.173403 8.831265 -6.716554 403 8802 + 8804 H -17.583234 8.325208 -7.157965 403 8802 + 8805 O 14.323717 15.125299 -5.725594 402 8806 8807 + 8806 H 15.041767 15.729064 -5.519842 403 8805 + 8807 H 13.765048 15.154023 -4.972067 403 8805 + 8808 O -19.909899 0.941274 -8.892043 402 8809 8810 + 8809 H -20.063118 1.882998 -8.670527 403 8808 + 8810 H -20.016683 0.615676 -7.987400 403 8808 + 8811 O -4.062922 0.518298 17.993285 402 8812 8813 + 8812 H -4.234902 1.391334 17.589117 403 8811 + 8813 H -4.820041 -0.077704 17.801729 403 8811 + 8814 O 26.232840 -11.346405 0.934374 402 8815 8816 + 8815 H 26.965729 -10.796137 1.273638 403 8814 + 8816 H 26.535197 -11.828470 0.207089 403 8814 + 8817 O 18.568052 -3.606897 4.561302 402 8818 8819 + 8818 H 17.633584 -3.536757 4.401867 403 8817 + 8819 H 18.956111 -3.197861 3.755933 403 8817 + 8820 O -23.855092 5.074567 4.116598 402 8821 8822 + 8821 H -23.064224 4.611628 4.537652 403 8820 + 8822 H -23.710838 5.025654 3.139103 403 8820 + 8823 O 26.437758 -20.018004 1.491909 402 8824 8825 + 8824 H 26.350439 -19.182255 1.070486 403 8823 + 8825 H 27.361760 -20.307715 1.508970 403 8823 + 8826 O -15.774583 11.702587 -19.124466 402 8827 8828 + 8827 H -15.128134 11.654611 -18.394652 403 8826 + 8828 H -16.197784 10.854994 -19.059229 403 8826 + 8829 O 13.604852 -5.588538 -11.240265 402 8830 8831 + 8830 H 13.941716 -4.779794 -10.783187 403 8829 + 8831 H 13.492173 -6.306084 -10.658525 403 8829 + 8832 O -4.406927 9.867817 9.346751 402 8833 8834 + 8833 H -5.311013 9.555296 9.655422 403 8832 + 8834 H -4.255731 10.665634 9.843775 403 8832 + 8835 O -5.324087 -1.607821 -19.326145 402 8836 8837 + 8836 H -5.081210 -2.540467 -19.512431 403 8835 + 8837 H -5.681118 -1.658898 -18.424650 403 8835 + 8838 O 7.210255 -0.591966 -13.016339 402 8839 8840 + 8839 H 7.132769 -0.267418 -12.059025 403 8838 + 8840 H 7.145986 0.215754 -13.558300 403 8838 + 8841 O 13.031739 18.007964 -16.574884 402 8842 8843 + 8842 H 13.701983 18.076453 -17.280260 403 8841 + 8843 H 13.560834 18.505150 -15.807835 403 8841 + 8844 O -4.939182 19.582248 2.433779 402 8845 8846 + 8845 H -4.348475 19.232076 1.705221 403 8844 + 8846 H -4.493649 20.306827 2.886563 403 8844 + 8847 O -26.648293 -0.947736 -17.385316 402 8848 8849 + 8848 H -26.109245 -1.287067 -18.123131 403 8847 + 8849 H -27.139044 -0.227784 -17.739830 403 8847 + 8850 O 19.417331 5.365442 -12.381828 402 8851 8852 + 8851 H 20.057565 6.030330 -12.629842 403 8850 + 8852 H 18.801680 5.841907 -11.794057 403 8850 + 8853 O -19.679332 -1.764604 -19.638774 402 8854 8855 + 8854 H -19.289416 -1.940059 -18.795824 403 8853 + 8855 H -19.719754 -0.802184 -19.615952 403 8853 + 8856 O 16.188925 -8.137607 9.745803 402 8857 8858 + 8857 H 15.895930 -8.655747 9.012990 403 8856 + 8858 H 15.671496 -7.334126 9.820282 403 8856 + 8859 O 17.367529 -1.265528 20.226689 402 8860 8861 + 8860 H 17.209414 -2.128384 20.612209 403 8859 + 8861 H 17.475811 -0.580216 20.915152 403 8859 + 8862 O 20.517093 9.728672 9.587262 402 8863 8864 + 8863 H 21.222551 9.963620 10.212987 403 8862 + 8864 H 19.824767 9.384636 10.113042 403 8862 + 8865 O -7.547448 20.192218 -20.533482 402 8866 8867 + 8866 H -6.695025 19.629425 -20.571646 403 8865 + 8867 H -8.008402 20.075383 -21.344144 403 8865 + 8868 O -16.582915 -1.120027 -4.095394 402 8869 8870 + 8869 H -16.849559 -0.208322 -4.049542 403 8868 + 8870 H -16.720426 -1.473779 -3.214581 403 8868 + 8871 O 4.785781 1.946407 13.103817 402 8872 8873 + 8872 H 4.799308 1.247503 12.424632 403 8871 + 8873 H 4.583242 1.575294 13.963927 403 8871 + 8874 O -8.165114 -12.900949 2.168446 402 8875 8876 + 8875 H -8.256829 -12.788477 3.143987 403 8874 + 8876 H -7.320909 -13.341131 2.150781 403 8874 + 8877 O -17.554071 -15.744741 -16.262189 402 8878 8879 + 8878 H -17.806278 -16.375423 -15.592159 403 8877 + 8879 H -18.351583 -15.356631 -16.607464 403 8877 + 8880 O 27.326866 4.195826 19.441977 402 8881 8882 + 8881 H 28.011431 4.581461 18.842795 403 8880 + 8882 H 26.527694 4.615286 19.081611 403 8880 + 8883 O -25.419970 -6.739402 -9.247054 402 8884 8885 + 8884 H -25.459364 -7.498417 -9.890859 403 8883 + 8885 H -24.515740 -6.409622 -9.324420 403 8883 + 8886 O -3.380308 -14.523714 -7.300867 402 8887 8888 + 8887 H -3.061003 -15.308131 -6.909980 403 8886 + 8888 H -2.917512 -14.327994 -8.109098 403 8886 + 8889 O 26.207829 15.728093 -19.215945 402 8890 8891 + 8890 H 25.966653 16.561497 -19.590938 403 8889 + 8891 H 26.062905 14.999376 -19.810656 403 8889 + 8892 O -18.866057 -0.711382 15.470718 402 8893 8894 + 8893 H -19.290122 -1.568096 15.298654 403 8892 + 8894 H -17.951441 -0.972639 15.451259 403 8892 + 8895 O 18.465047 8.813449 11.216472 402 8896 8897 + 8896 H 18.798663 8.151346 11.818158 403 8895 + 8897 H 17.716063 8.381682 10.839333 403 8895 + 8898 O -24.781204 -20.600352 -18.705084 402 8899 8900 + 8899 H -25.022898 -19.710672 -18.985244 403 8898 + 8900 H -25.460136 -21.155945 -19.120654 403 8898 + 8901 O 22.729959 2.205214 -7.072615 402 8902 8903 + 8902 H 22.357169 1.293535 -7.021078 403 8901 + 8903 H 22.701750 2.488699 -7.961356 403 8901 + 8904 O 12.690918 2.750591 12.342202 402 8905 8906 + 8905 H 12.532985 3.617962 11.878555 403 8904 + 8906 H 13.133585 2.199071 11.681589 403 8904 + 8907 O 24.106980 -11.846114 14.571893 402 8908 8909 + 8908 H 23.699036 -11.148912 15.134462 403 8907 + 8909 H 23.233694 -12.194399 14.228632 403 8907 + 8910 O 0.015177 -14.005197 -19.056743 402 8911 8912 + 8911 H -0.340775 -13.532157 -18.287023 403 8910 + 8912 H -0.773966 -14.258584 -19.587550 403 8910 + 8913 O 12.361724 4.484402 -15.999210 402 8914 8915 + 8914 H 12.200963 5.407914 -16.093788 403 8913 + 8915 H 11.619804 4.000673 -15.643034 403 8913 + 8916 O -4.332154 14.465183 5.913532 402 8917 8918 + 8917 H -3.550293 15.013973 5.769350 403 8916 + 8918 H -4.511279 14.482735 6.928514 403 8916 + 8919 O -2.423184 -19.036991 20.142811 402 8920 8921 + 8920 H -2.033960 -18.570661 20.871778 403 8919 + 8921 H -2.200093 -18.567230 19.324641 403 8919 + 8922 O -11.400807 16.524027 12.877501 402 8923 8924 + 8923 H -10.684181 16.008719 12.380621 403 8922 + 8924 H -12.191788 16.488834 12.343702 403 8922 + 8925 O 15.966093 16.748739 -1.323378 402 8926 8927 + 8926 H 16.412638 17.338758 -1.989326 403 8925 + 8927 H 15.598457 17.376590 -0.651299 403 8925 + 8928 O 23.415752 18.871243 -18.062665 402 8929 8930 + 8929 H 23.451778 19.269195 -17.182012 403 8928 + 8930 H 22.494121 18.975734 -18.366439 403 8928 + 8931 O -8.572201 3.275476 -10.014766 402 8932 8933 + 8932 H -9.403406 3.269988 -10.503336 403 8931 + 8933 H -8.724278 3.329701 -9.074127 403 8931 + 8934 O -11.585480 -0.851627 12.287499 402 8935 8936 + 8935 H -11.320746 -0.082366 12.769641 403 8934 + 8936 H -11.472816 -0.637183 11.362553 403 8934 + 8937 O 7.497602 -9.434427 -12.321588 402 8938 8939 + 8938 H 8.071421 -10.126251 -12.076632 403 8937 + 8939 H 8.042121 -8.593371 -12.397957 403 8937 + 8940 O 4.778213 -10.266015 -19.410251 402 8941 8942 + 8941 H 5.274109 -9.668837 -18.817242 403 8940 + 8942 H 4.120565 -9.651627 -19.758229 403 8940 + 8943 O -6.111007 -15.043780 2.679188 402 8944 8945 + 8944 H -5.289890 -15.200515 3.239461 403 8943 + 8945 H -6.645239 -15.919834 2.758924 403 8943 + 8946 O -19.627428 -18.648983 -20.285776 402 8947 8948 + 8947 H -18.763886 -19.012576 -20.099994 403 8946 + 8948 H -19.447444 -17.996380 -20.946059 403 8946 + 8949 O 9.799336 -4.134177 -14.605227 402 8950 8951 + 8950 H 9.726430 -3.298650 -14.107003 403 8949 + 8951 H 10.588497 -4.491055 -14.189406 403 8949 + 8952 O 6.956853 10.981174 -15.927933 402 8953 8954 + 8953 H 6.333575 10.252829 -16.183246 403 8952 + 8954 H 7.290948 10.697439 -15.077221 403 8952 + 8955 O 15.996505 -7.421222 -2.982722 402 8956 8957 + 8956 H 16.037378 -8.363657 -3.163947 403 8955 + 8957 H 15.971488 -7.414229 -2.004616 403 8955 + 8958 O 24.116659 17.319712 -5.748450 402 8959 8960 + 8959 H 24.717303 17.575301 -5.045222 403 8958 + 8960 H 24.154648 16.310133 -5.689457 403 8958 + 8961 O -25.014350 19.047244 5.636389 402 8962 8963 + 8962 H -24.831592 18.532801 6.467994 403 8961 + 8963 H -25.569417 19.791621 5.840508 403 8961 + 8964 O -13.760710 14.201790 -16.036971 402 8965 8966 + 8965 H -13.882187 15.099458 -16.440666 403 8964 + 8966 H -13.724599 14.326841 -15.088458 403 8964 + 8967 O -24.389392 17.787413 -4.553817 402 8968 8969 + 8968 H -24.972675 18.418071 -5.068364 403 8967 + 8969 H -24.356964 18.276421 -3.698179 403 8967 + 8970 O -18.723840 -6.150098 -13.057313 402 8971 8972 + 8971 H -18.318192 -6.956567 -12.670367 403 8970 + 8972 H -17.968230 -5.629913 -13.262178 403 8970 + 8973 O 0.195836 -4.045493 20.385139 402 8974 8975 + 8974 H 0.549498 -4.632208 21.063706 403 8973 + 8975 H -0.603773 -4.486592 20.007533 403 8973 + 8976 O -5.473498 -2.320372 -16.638624 402 8977 8978 + 8977 H -5.812762 -2.143253 -15.717531 403 8976 + 8978 H -5.163919 -3.274843 -16.629360 403 8976 + 8979 O 21.657434 10.195244 -12.556194 402 8980 8981 + 8980 H 21.466450 11.110479 -12.686972 403 8979 + 8981 H 21.662028 10.206355 -11.604800 403 8979 + 8982 O -18.526380 -11.853303 0.119709 402 8983 8984 + 8983 H -18.677742 -12.441590 -0.589422 403 8982 + 8984 H -18.075660 -11.001968 -0.204346 403 8982 + 8985 O -19.755563 -18.537381 -2.766741 402 8986 8987 + 8986 H -19.962233 -18.408807 -3.703137 403 8985 + 8987 H -19.999131 -17.782990 -2.372006 403 8985 + 8988 O 25.476128 17.625846 -3.184333 402 8989 8990 + 8989 H 26.203145 17.076934 -2.886644 403 8988 + 8990 H 25.710710 18.493253 -2.850200 403 8988 + 8991 O -22.305377 1.710018 15.373391 402 8992 8993 + 8992 H -22.044667 1.930929 16.308564 403 8991 + 8993 H -22.836038 0.853232 15.392466 403 8991 + 8994 O 2.757401 -15.671844 -1.738405 402 8995 8996 + 8995 H 2.387180 -15.115097 -1.096143 403 8994 + 8996 H 3.413578 -16.267070 -1.380191 403 8994 + 8997 O 25.430670 -2.334847 6.648866 402 8998 8999 + 8998 H 25.893201 -2.829135 7.309607 403 8997 + 8999 H 24.545839 -2.463509 7.030661 403 8997 + 9000 O 3.889750 2.458553 -20.722084 402 9001 9002 + 9001 H 3.444777 1.541092 -20.936428 403 9000 + 9002 H 3.192280 2.998470 -20.481554 403 9000 + 9003 O 19.435277 -5.919201 6.178342 402 9004 9005 + 9004 H 18.742497 -6.147165 6.835144 403 9003 + 9005 H 19.082846 -5.397301 5.451949 403 9003 + 9006 O -1.325956 10.838557 -7.120140 402 9007 9008 + 9007 H -1.379491 10.683558 -6.153949 403 9006 + 9008 H -1.024828 11.727198 -7.077078 403 9006 + 9009 O -3.710126 14.086716 -7.244913 402 9010 9011 + 9010 H -4.337761 13.541137 -7.799347 403 9009 + 9011 H -4.000550 13.881396 -6.362053 403 9009 + 9012 O 14.433778 -1.890208 -13.881242 402 9013 9014 + 9013 H 13.768753 -2.557931 -14.088173 403 9012 + 9014 H 14.194801 -1.387777 -13.039639 403 9012 + 9015 O -18.934813 -1.053060 1.293190 402 9016 9017 + 9016 H -19.547923 -0.821685 1.967866 403 9015 + 9017 H -18.094001 -0.641682 1.660883 403 9015 + 9018 O -22.405398 -20.039410 9.627718 402 9019 9020 + 9019 H -22.796434 -20.600182 8.972850 403 9018 + 9020 H -22.131968 -19.299630 9.083235 403 9018 + 9021 O -1.229753 11.457428 10.074790 402 9022 9023 + 9022 H -0.334237 11.703470 10.327241 403 9021 + 9023 H -1.157156 10.837370 9.316439 403 9021 + 9024 O 25.443002 2.066902 -6.888756 402 9025 9026 + 9025 H 25.641541 2.915762 -7.359788 403 9024 + 9026 H 24.465208 2.093523 -6.739748 403 9024 + 9027 O -16.581214 16.377510 -14.832297 402 9028 9029 + 9028 H -16.587099 15.904994 -13.968869 403 9027 + 9029 H -16.866698 17.278853 -14.742235 403 9027 + 9030 O 11.983368 11.828299 -3.823724 402 9031 9032 + 9031 H 12.336985 12.445002 -3.178218 403 9030 + 9032 H 11.049304 11.604866 -3.665958 403 9030 + 9033 O 21.164572 -1.185333 -16.015117 402 9034 9035 + 9034 H 20.715162 -0.431609 -16.354646 403 9033 + 9035 H 20.819380 -1.264906 -15.151962 403 9033 + 9036 O 5.457366 -10.657358 -13.800772 402 9037 9038 + 9037 H 4.779858 -10.165440 -14.279853 403 9036 + 9038 H 6.212045 -10.040539 -13.706945 403 9036 + 9039 O -16.423429 10.434483 -15.277807 402 9040 9041 + 9040 H -15.708526 10.928082 -15.699592 403 9039 + 9041 H -15.960741 9.897443 -14.616298 403 9039 + 9042 O -20.419587 -19.665938 5.773644 402 9043 9044 + 9043 H -21.363895 -19.581010 6.013361 403 9042 + 9044 H -19.853905 -19.280863 6.468747 403 9042 + 9045 O 19.508036 -18.494331 8.912926 402 9046 9047 + 9046 H 19.727428 -18.712582 9.835185 403 9045 + 9047 H 19.913134 -19.105692 8.298087 403 9045 + 9048 O 19.742354 -2.749373 18.946243 402 9049 9050 + 9049 H 20.356111 -2.867791 19.687152 403 9048 + 9050 H 19.073759 -2.160527 19.341368 403 9048 + 9051 O 19.005725 16.659102 -4.024674 402 9052 9053 + 9052 H 18.186097 16.480938 -4.427734 403 9051 + 9053 H 18.814608 17.298422 -3.358553 403 9051 + 9054 O -8.835887 18.312505 -7.442487 402 9055 9056 + 9055 H -8.830492 17.732483 -8.193218 403 9054 + 9056 H -9.752425 18.649905 -7.404203 403 9054 + 9057 O -17.336326 4.931650 10.634975 402 9058 9059 + 9058 H -16.450097 5.217439 10.271982 403 9057 + 9059 H -17.882557 4.558518 9.889708 403 9057 + 9060 O -3.010824 -5.905956 6.847801 402 9061 9062 + 9061 H -2.748688 -5.113745 6.359917 403 9060 + 9062 H -2.163371 -6.028171 7.336259 403 9060 + 9063 O 26.674110 12.326845 1.003397 402 9064 9065 + 9064 H 26.498840 12.357411 1.941376 403 9063 + 9065 H 26.095376 11.585032 0.663483 403 9063 + 9066 O -3.647702 -6.137587 13.529843 402 9067 9068 + 9067 H -3.585661 -5.496886 12.804045 403 9066 + 9068 H -3.582668 -6.993279 13.154224 403 9066 + 9069 O 1.988731 3.642853 -17.323133 402 9070 9071 + 9070 H 1.657523 3.030179 -16.746788 403 9069 + 9071 H 1.714357 4.548463 -17.022125 403 9069 + 9072 O -21.467906 15.279507 16.450567 402 9073 9074 + 9073 H -21.342432 15.396388 15.459294 403 9072 + 9074 H -21.255917 16.108495 16.873553 403 9072 + 9075 O 10.722659 -15.332451 -4.565762 402 9076 9077 + 9076 H 10.219128 -14.832093 -3.873147 403 9075 + 9077 H 11.478425 -15.649236 -4.183169 403 9075 + 9078 O -15.362943 8.381189 -9.911049 402 9079 9080 + 9079 H -15.790421 8.852870 -9.163602 403 9078 + 9080 H -15.901457 8.456340 -10.687883 403 9078 + 9081 O -6.117005 -17.666075 11.598739 402 9082 9083 + 9082 H -5.807530 -18.593273 11.402299 403 9081 + 9083 H -5.391363 -17.258909 12.082625 403 9081 + 9084 O 15.809786 8.519937 -19.377408 402 9085 9086 + 9085 H 15.758815 8.522648 -20.341707 403 9084 + 9086 H 15.420577 9.368007 -19.123689 403 9084 + 9087 O 16.939240 -18.373645 7.950825 402 9088 9089 + 9088 H 17.207858 -18.006941 7.092997 403 9087 + 9089 H 17.812610 -18.447723 8.295733 403 9087 + 9090 O -12.507522 -15.054493 6.331021 402 9091 9092 + 9091 H -13.226017 -14.420799 6.460827 403 9090 + 9092 H -11.849976 -14.561229 5.786593 403 9090 + 9093 O -18.182152 4.799952 -11.866172 402 9094 9095 + 9094 H -18.038039 4.897463 -10.917789 403 9093 + 9095 H -18.695958 4.021311 -12.029165 403 9093 + 9096 O -9.377203 11.614184 3.311631 402 9097 9098 + 9097 H -9.092786 10.701027 3.311174 403 9096 + 9098 H -8.739940 12.083447 3.909937 403 9096 + 9099 O 24.894256 -5.525807 -20.636863 402 9100 9101 + 9100 H 24.507335 -5.547278 -19.753182 403 9099 + 9101 H 25.790020 -5.247577 -20.418409 403 9099 + 9102 O -23.172834 -17.188227 2.440789 402 9103 9104 + 9103 H -23.395171 -18.018880 2.825747 403 9102 + 9104 H -22.193387 -17.125237 2.517058 403 9102 + 9105 O 24.135008 -19.930490 -4.684991 402 9106 9107 + 9106 H 24.122289 -18.925946 -4.803857 403 9105 + 9107 H 24.712920 -20.215229 -5.372877 403 9105 + 9108 O -17.792076 11.534192 15.059996 402 9109 9110 + 9109 H -16.965370 11.797213 15.470927 403 9108 + 9110 H -18.560988 11.913780 15.443831 403 9108 + 9111 O -18.514941 20.339905 -0.125520 402 9112 9113 + 9112 H -18.667243 19.462095 -0.535183 403 9111 + 9113 H -18.065408 20.873029 -0.719025 403 9111 + 9114 O -22.940337 -3.988570 -9.248839 402 9115 9116 + 9115 H -22.556330 -3.193733 -8.929657 403 9114 + 9116 H -23.624559 -3.640649 -9.848732 403 9114 + 9117 O 12.039511 -1.981999 -19.397718 402 9118 9119 + 9118 H 12.283853 -1.068627 -19.717430 403 9117 + 9119 H 11.293173 -1.821725 -18.743785 403 9117 + 9120 O 26.340624 1.335259 19.289276 402 9121 9122 + 9121 H 26.841055 0.655996 19.819897 403 9120 + 9122 H 26.800288 2.181296 19.386054 403 9120 + 9123 O 5.916695 14.316365 5.690974 402 9124 9125 + 9124 H 6.301016 14.102416 4.790199 403 9123 + 9125 H 5.065517 13.849361 5.701154 403 9123 + 9126 O 13.370348 -18.821001 19.162682 402 9127 9128 + 9127 H 14.108633 -19.097802 18.663220 403 9126 + 9128 H 13.699085 -18.168012 19.800526 403 9126 + 9129 O 23.405805 15.068779 9.736213 402 9130 9131 + 9130 H 22.573160 14.660972 10.019951 403 9129 + 9131 H 23.219623 15.734719 9.058682 403 9129 + 9132 O -5.408829 13.828838 18.447419 402 9133 9134 + 9133 H -6.168561 13.481395 17.992340 403 9132 + 9134 H -4.784831 14.172206 17.836655 403 9132 + 9135 O -13.245623 5.670961 -0.018513 402 9136 9137 + 9136 H -12.419620 5.936404 0.475256 403 9135 + 9137 H -12.953928 4.989305 -0.645525 403 9135 + 9138 O 17.249203 -6.366308 2.555121 402 9139 9140 + 9139 H 18.196321 -6.281038 2.412817 403 9138 + 9140 H 16.966298 -7.253693 2.384394 403 9138 + 9141 O -5.296416 19.864731 -1.668047 402 9142 9143 + 9142 H -5.749980 19.031441 -1.444019 403 9141 + 9143 H -4.299943 19.722461 -1.604460 403 9141 + 9144 O -16.684535 5.831070 -9.866261 402 9145 9146 + 9145 H -17.133431 6.510584 -9.314798 403 9144 + 9146 H -15.783199 6.112174 -9.905469 403 9144 + 9147 O 16.265639 6.852785 -7.896636 402 9148 9149 + 9148 H 16.527802 6.700601 -8.808419 403 9147 + 9149 H 17.070642 6.577942 -7.414049 403 9147 + 9150 O -21.312105 18.191924 10.459876 402 9151 9152 + 9151 H -20.762633 18.843032 9.983997 403 9150 + 9152 H -20.749711 17.337404 10.555555 403 9150 + 9153 O -16.100357 -8.153697 -5.142815 402 9154 9155 + 9154 H -16.563606 -8.364758 -6.004467 403 9153 + 9155 H -15.154250 -7.906094 -5.382181 403 9153 + 9156 O -9.615286 13.091225 20.211510 402 9157 9158 + 9157 H -9.791366 12.655362 19.395743 403 9156 + 9158 H -10.462726 13.102852 20.699120 403 9156 + 9159 O -18.598056 -9.697384 8.839376 402 9160 9161 + 9160 H -18.669310 -10.516686 9.343906 403 9159 + 9161 H -18.931363 -8.964428 9.385541 403 9159 + 9162 O 7.933987 -14.093590 6.186519 402 9163 9164 + 9163 H 8.207527 -14.668399 6.884006 403 9162 + 9164 H 8.301922 -13.235214 6.418423 403 9162 + 9165 O 14.288937 4.874936 -8.228821 402 9166 9167 + 9166 H 13.542574 5.155680 -8.863279 403 9165 + 9167 H 14.810343 5.654336 -8.058197 403 9165 + 9168 O 12.246994 8.643633 9.863872 402 9169 9170 + 9169 H 12.726549 8.831956 10.652198 403 9168 + 9170 H 11.373287 8.283693 10.003012 403 9168 + 9171 O -25.270711 -9.927997 8.533897 402 9172 9173 + 9172 H -24.762785 -10.112710 9.286810 403 9171 + 9173 H -25.238676 -10.761122 8.058752 403 9171 + 9174 O 22.391162 10.881778 -20.435148 402 9175 9176 + 9175 H 21.795271 11.117663 -21.128050 403 9174 + 9176 H 22.356795 11.558284 -19.773744 403 9174 + 9177 O -0.807548 -14.371789 12.994860 402 9178 9179 + 9178 H 0.169556 -14.376294 13.074982 403 9177 + 9179 H -1.104471 -13.660037 12.471373 403 9177 + 9180 O 7.732198 13.812736 20.037022 402 9181 9182 + 9181 H 8.322105 14.100985 20.697382 403 9180 + 9182 H 7.280009 14.639584 19.691732 403 9180 + 9183 O 19.803756 0.841082 -17.134900 402 9184 9185 + 9184 H 19.288798 0.974936 -16.312323 403 9183 + 9185 H 20.344973 1.668924 -17.222026 403 9183 + 9186 O 3.006216 10.098697 2.949568 402 9187 9188 + 9187 H 2.578021 10.984530 2.806805 403 9186 + 9188 H 3.907142 10.297785 3.184074 403 9186 + 9189 O 15.873541 13.013460 -17.893320 402 9190 9191 + 9190 H 15.039690 13.457379 -17.843027 403 9189 + 9191 H 16.307486 13.271147 -17.069099 403 9189 + 9192 O 17.084293 4.346353 -14.985379 402 9193 9194 + 9193 H 16.897186 4.218804 -15.905422 403 9192 + 9194 H 18.061148 4.233803 -14.912436 403 9192 + 9195 O -21.371098 -2.500601 10.634104 402 9196 9197 + 9196 H -21.050859 -3.246995 11.070174 403 9195 + 9197 H -21.156581 -2.501005 9.672558 403 9195 + 9198 O -18.750890 1.105436 13.107103 402 9199 9200 + 9199 H -19.405065 0.422507 13.292755 403 9198 + 9200 H -18.176163 1.261421 13.836264 403 9198 + 9201 O -14.137019 19.297443 5.108564 402 9202 9203 + 9202 H -14.447107 19.586959 4.301598 403 9201 + 9203 H -14.859255 19.041560 5.714699 403 9201 + 9204 O 2.347144 -4.353199 10.184512 402 9205 9206 + 9205 H 3.047693 -4.789736 10.732160 403 9204 + 9206 H 1.864240 -5.020658 9.719618 403 9204 + 9207 O 8.101274 -12.868709 15.865572 402 9208 9209 + 9208 H 9.008432 -13.290947 15.950755 403 9207 + 9209 H 8.164041 -12.117937 16.446599 403 9207 + 9210 O -7.675769 -15.390059 12.539289 402 9211 9212 + 9211 H -7.409496 -14.626553 11.915042 403 9210 + 9212 H -7.614755 -16.191218 12.009248 403 9210 + 9213 O -21.398277 17.515428 0.659811 402 9214 9215 + 9214 H -22.373476 17.461084 0.916402 403 9213 + 9215 H -21.187696 16.555626 0.790839 403 9213 + 9216 O -16.011532 15.600476 -5.525384 402 9217 9218 + 9217 H -15.829552 14.648078 -5.450075 403 9216 + 9218 H -15.676036 15.915857 -6.377072 403 9216 + 9219 O -20.171456 -7.558847 9.362228 402 9220 9221 + 9220 H -19.542732 -6.922489 9.041804 403 9219 + 9221 H -20.565885 -7.210783 10.122068 403 9219 + 9222 O -10.027028 2.569851 14.780708 402 9223 9224 + 9223 H -10.957643 2.497925 14.922514 403 9222 + 9224 H -9.726024 3.392205 15.205842 403 9222 + 9225 O -12.389641 -3.630575 19.832870 402 9226 9227 + 9226 H -12.243221 -2.721357 19.438252 403 9225 + 9227 H -11.816036 -4.199902 19.239521 403 9225 + 9228 O 18.688398 -15.142019 -11.646870 402 9229 9230 + 9229 H 18.104901 -15.132683 -12.455435 403 9228 + 9230 H 19.565818 -14.972254 -11.954461 403 9228 + 9231 O -16.127768 -4.186936 16.465789 402 9232 9233 + 9232 H -16.199826 -5.136635 16.281789 403 9231 + 9233 H -15.213417 -3.948084 16.556706 403 9231 + 9234 O -5.695916 9.820869 12.533783 402 9235 9236 + 9235 H -6.081058 9.297651 11.888045 403 9234 + 9236 H -6.375197 10.194994 13.105807 403 9234 + 9237 O -11.767595 7.371441 19.819990 402 9238 9239 + 9238 H -12.489308 7.774706 20.373473 403 9237 + 9239 H -10.903774 7.497881 20.264329 403 9237 + 9240 O -18.646029 -3.188135 4.429231 402 9241 9242 + 9241 H -18.121897 -2.394969 4.628228 403 9240 + 9242 H -19.564881 -3.024196 4.677418 403 9240 + 9243 O -27.199358 17.790334 15.106308 402 9244 9245 + 9244 H -27.385927 16.881826 14.776421 403 9243 + 9245 H -27.100030 17.729872 16.057267 403 9243 + 9246 O 18.093363 3.769702 -4.593442 402 9247 9248 + 9247 H 18.609903 3.037301 -4.942422 403 9246 + 9248 H 18.650829 4.233336 -3.997439 403 9246 + 9249 O 7.706432 11.586595 6.521802 402 9250 9251 + 9250 H 7.812472 12.398627 6.995928 403 9249 + 9251 H 7.694286 11.737503 5.595545 403 9249 + 9252 O -23.496957 14.349318 18.036220 402 9253 9254 + 9253 H -22.854057 14.699094 17.423607 403 9252 + 9254 H -22.990832 13.822071 18.687726 403 9252 + 9255 O -4.664327 -11.498090 8.919813 402 9256 9257 + 9256 H -5.320061 -11.113845 8.334147 403 9255 + 9257 H -4.917357 -12.403653 9.095316 403 9255 + 9258 O -12.823426 10.100060 12.766547 402 9259 9260 + 9259 H -13.732598 9.891677 12.621183 403 9258 + 9260 H -12.785614 10.926980 13.238539 403 9258 + 9261 O -17.217436 3.102574 -9.344857 402 9262 9263 + 9262 H -16.824523 3.966216 -9.255133 403 9261 + 9263 H -18.161389 3.114177 -9.202666 403 9261 + 9264 O -19.237099 13.102459 19.268997 402 9265 9266 + 9265 H -18.881981 13.843795 19.761617 403 9264 + 9266 H -18.662460 12.340333 19.526666 403 9264 + 9267 O -9.459329 4.127006 -20.423384 402 9268 9269 + 9268 H -9.437953 4.152565 -21.392157 403 9267 + 9269 H -9.259556 3.201676 -20.170944 403 9267 + 9270 O 16.881832 1.847629 -10.429065 402 9271 9272 + 9271 H 16.137346 2.355903 -10.841218 403 9270 + 9272 H 16.970716 2.383474 -9.646384 403 9270 + 9273 O 14.087997 4.886317 -18.329611 402 9274 9275 + 9274 H 13.870527 5.790902 -18.194453 403 9273 + 9275 H 13.733176 4.313827 -17.614840 403 9273 + 9276 O -16.672076 -8.158476 12.371072 402 9277 9278 + 9277 H -16.864374 -8.959184 11.822666 403 9276 + 9278 H -15.812107 -8.255964 12.755980 403 9276 + 9279 O -19.299758 3.045618 -4.235388 402 9280 9281 + 9280 H -19.897059 2.549328 -3.677605 403 9279 + 9281 H -19.150628 3.861874 -3.750292 403 9279 + 9282 O -23.652514 -4.511442 -6.532734 402 9283 9284 + 9283 H -22.727919 -4.287115 -6.467785 403 9282 + 9284 H -23.794359 -4.367125 -7.440392 403 9282 + 9285 O -2.920139 11.742479 14.018818 402 9286 9287 + 9286 H -3.093279 11.094202 13.278761 403 9285 + 9287 H -2.213003 12.387804 13.722639 403 9285 + 9288 O 26.349425 3.441434 -0.896655 402 9289 9290 + 9289 H 25.559323 3.941367 -0.786766 403 9288 + 9290 H 26.827837 3.589174 -1.727789 403 9288 + 9291 O 24.371024 -6.950117 11.157076 402 9292 9293 + 9292 H 24.363949 -7.335870 12.010991 403 9291 + 9293 H 23.997586 -7.623084 10.641501 403 9291 + 9294 O -22.986862 7.597219 -10.685297 402 9295 9296 + 9295 H -22.839220 7.363568 -11.582970 403 9294 + 9296 H -23.377355 8.488181 -10.698170 403 9294 + 9297 O -26.260863 2.606900 0.424694 402 9298 9299 + 9298 H -25.763469 2.340546 -0.362004 403 9297 + 9299 H -27.210163 2.597209 0.142899 403 9297 + 9300 O -12.863331 19.210721 9.863577 402 9301 9302 + 9301 H -12.261758 19.250393 10.674962 403 9300 + 9302 H -13.524604 18.506027 9.993308 403 9300 + 9303 O -21.978336 -14.820148 8.330413 402 9304 9305 + 9304 H -21.114644 -14.929597 7.888749 403 9303 + 9305 H -21.801101 -14.612357 9.239922 403 9303 + 9306 O 4.170159 8.312971 19.162038 402 9307 9308 + 9307 H 4.570566 7.905151 18.357550 403 9306 + 9308 H 3.241810 8.258885 18.904642 403 9306 + 9309 O 20.797031 -12.724867 -4.841837 402 9310 9311 + 9310 H 20.936034 -13.677427 -4.931553 403 9309 + 9311 H 21.567394 -12.221377 -4.833917 403 9309 + 9312 O 13.112963 4.999431 10.925314 402 9313 9314 + 9313 H 13.381193 5.910915 11.162187 403 9312 + 9314 H 12.775168 5.031277 10.023795 403 9312 + 9315 O -17.488498 18.101828 -9.390547 402 9316 9317 + 9316 H -16.811412 18.773847 -9.686587 403 9315 + 9317 H -17.803299 18.410345 -8.511456 403 9315 + 9318 O 17.749103 -8.641103 -11.171278 402 9319 9320 + 9319 H 17.842099 -7.910400 -11.803229 403 9318 + 9320 H 18.554099 -8.647320 -10.650095 403 9318 + 9321 O 23.187132 -9.133014 9.904940 402 9322 9323 + 9322 H 23.460415 -9.970033 10.292082 403 9321 + 9323 H 22.233888 -9.184916 9.742240 403 9321 + 9324 O 14.891551 9.368784 -7.655561 402 9325 9326 + 9325 H 15.425686 8.571538 -7.734882 403 9324 + 9326 H 15.193600 9.946038 -8.368338 403 9324 + 9327 O -23.866954 -2.554397 -3.337520 402 9328 9329 + 9328 H -23.349227 -3.276607 -2.890486 403 9327 + 9329 H -24.593652 -2.997738 -3.796287 403 9327 + 9330 O 5.289348 -7.469003 -13.632279 402 9331 9332 + 9331 H 5.277377 -6.512734 -13.514077 403 9330 + 9332 H 5.158552 -7.590503 -14.588796 403 9330 + 9333 O -24.673900 -20.221091 14.116865 402 9334 9335 + 9334 H -24.507583 -21.124377 14.341508 403 9333 + 9335 H -24.631103 -20.019803 13.186904 403 9333 + 9336 O 23.849959 -2.905384 -13.612324 402 9337 9338 + 9337 H 23.991560 -2.301635 -14.360144 403 9336 + 9338 H 23.035961 -3.322471 -13.648750 403 9336 + 9339 O 9.597419 13.539609 16.458855 402 9340 9341 + 9340 H 8.786247 13.049602 16.392590 403 9339 + 9341 H 9.783350 13.953319 15.588815 403 9339 + 9342 O 25.970484 6.179678 15.798539 402 9343 9344 + 9343 H 26.018959 6.019011 14.863720 403 9342 + 9344 H 26.760326 5.647911 16.135033 403 9342 + 9345 O 15.995160 -8.299211 -19.360180 402 9346 9347 + 9346 H 16.084534 -7.778026 -20.183460 403 9345 + 9347 H 16.045247 -9.240694 -19.615365 403 9345 + 9348 O -14.294639 13.545693 12.129310 402 9349 9350 + 9349 H -14.596139 13.059241 11.355518 403 9348 + 9350 H -13.936091 12.903120 12.762555 403 9348 + 9351 O -19.407809 -1.632719 -10.223791 402 9352 9353 + 9352 H -18.944881 -0.931680 -10.694558 403 9351 + 9353 H -19.337036 -2.518503 -10.649693 403 9351 + 9354 O 19.353851 17.575670 17.852735 402 9355 9356 + 9355 H 19.970328 18.410638 17.937921 403 9354 + 9356 H 18.705869 17.842357 17.182350 403 9354 + 9357 O 7.952485 -13.835833 10.779314 402 9358 9359 + 9358 H 8.503126 -13.070419 11.090754 403 9357 + 9359 H 7.207795 -13.430815 10.322018 403 9357 + 9360 O -22.842698 -2.314944 16.647836 402 9361 9362 + 9361 H -23.333149 -1.519155 16.340397 403 9360 + 9362 H -23.463394 -3.038396 16.463743 403 9360 + 9363 O -19.201717 2.632915 18.127454 402 9364 9365 + 9364 H -20.123441 2.325926 18.179315 403 9363 + 9365 H -19.210821 3.510831 17.811602 403 9363 + 9366 O 14.940360 -1.960385 -5.022951 402 9367 9368 + 9367 H 15.464903 -2.467492 -5.627366 403 9366 + 9368 H 15.028383 -1.068080 -5.249177 403 9366 + 9369 O 18.305226 -9.507548 11.469011 402 9370 9371 + 9370 H 18.631115 -9.386360 12.404545 403 9369 + 9371 H 17.861273 -8.670836 11.223009 403 9369 + 9372 O 14.602066 10.381034 5.005010 402 9373 9374 + 9373 H 13.693795 10.430464 4.699453 403 9372 + 9374 H 14.612959 10.041819 5.921815 403 9372 + 9375 O 2.027713 14.335519 -2.737302 402 9376 9377 + 9376 H 2.701727 15.041848 -2.820213 403 9375 + 9377 H 1.287972 14.760203 -2.236217 403 9375 + 9378 O 7.583318 14.155640 -9.444813 402 9379 9380 + 9379 H 6.943304 13.664978 -8.934443 403 9378 + 9380 H 7.541292 15.069839 -9.060789 403 9378 + 9381 O 6.157219 -18.775945 -4.259618 402 9382 9383 + 9382 H 6.564876 -17.949995 -4.135465 403 9381 + 9383 H 5.381952 -18.685791 -4.858352 403 9381 + 9384 O -17.694760 -19.372982 4.444716 402 9385 9386 + 9385 H -18.482553 -19.775840 4.189782 403 9384 + 9386 H -17.768985 -18.373906 4.216234 403 9384 + 9387 O -7.853241 -10.893164 5.893751 402 9388 9389 + 9388 H -8.018175 -11.113207 6.770281 403 9387 + 9389 H -8.721602 -10.559022 5.533534 403 9387 + 9390 O -0.179053 -16.316262 -6.972426 402 9391 9392 + 9391 H -0.917372 -16.443486 -6.358316 403 9390 + 9392 H 0.161491 -15.370029 -6.873414 403 9390 + 9393 O -17.840107 2.077389 4.804516 402 9394 9395 + 9394 H -18.321956 2.898522 4.546830 403 9393 + 9395 H -17.883766 1.968309 5.738130 403 9393 + 9396 O 22.514225 -13.301014 8.910658 402 9397 9398 + 9397 H 22.980267 -13.555893 9.738284 403 9396 + 9398 H 22.816838 -13.961875 8.319245 403 9396 + 9399 O 8.642838 -14.756688 -17.347259 402 9400 9401 + 9400 H 7.685639 -14.854800 -17.271066 403 9399 + 9401 H 9.104821 -15.542415 -17.427483 403 9399 + 9402 O 1.148414 -18.182410 2.438452 402 9403 9404 + 9403 H 1.244513 -18.018729 1.471145 403 9402 + 9404 H 0.297784 -18.622295 2.484621 403 9402 + 9405 O -0.615129 -11.682105 -14.874888 402 9406 9407 + 9406 H -0.743014 -12.466140 -15.424873 403 9405 + 9407 H -0.401037 -10.992229 -15.542345 403 9405 + 9408 O 0.382292 8.435158 -17.928055 402 9409 9410 + 9409 H 1.324448 8.603691 -17.753474 403 9408 + 9410 H -0.034745 8.730008 -17.117939 403 9408 + 9411 O 16.913096 -13.325161 -8.541691 402 9412 9413 + 9412 H 17.365381 -13.123665 -7.714485 403 9411 + 9413 H 17.395114 -14.047333 -9.044404 403 9411 + 9414 O -21.295513 -11.021940 0.140848 402 9415 9416 + 9415 H -20.399742 -11.414489 0.196618 403 9414 + 9416 H -21.717453 -11.457849 -0.596997 403 9414 + 9417 O 16.257153 -20.396691 -7.748186 402 9418 9419 + 9418 H 15.866593 -21.141436 -8.252209 403 9417 + 9419 H 16.774217 -20.799101 -7.019481 403 9417 + 9420 O 0.208862 17.804049 -6.156398 402 9421 9422 + 9421 H -0.761445 17.806961 -6.377662 403 9420 + 9422 H 0.362977 16.942869 -5.716103 403 9420 + 9423 O 16.820504 12.298715 0.018055 402 9424 9425 + 9424 H 17.269628 12.806166 0.753963 403 9423 + 9425 H 16.616966 11.447779 0.422257 403 9423 + 9426 O 8.249689 9.539413 -5.657026 402 9427 9428 + 9427 H 7.926267 8.961633 -4.961649 403 9426 + 9428 H 7.466873 9.988595 -6.079963 403 9426 + 9429 O -6.420145 -15.194726 -2.072771 402 9430 9431 + 9430 H -6.645150 -15.017421 -2.971457 403 9429 + 9431 H -5.532921 -14.874756 -2.025757 403 9429 + 9432 O -19.505572 1.070481 -18.793079 402 9433 9434 + 9433 H -18.974247 1.767142 -19.229226 403 9432 + 9434 H -19.357244 1.271413 -17.799689 403 9432 + 9435 O 20.278433 -11.278541 19.375197 402 9436 9437 + 9436 H 20.311617 -10.856797 20.258994 403 9435 + 9437 H 20.934421 -12.034086 19.419062 403 9435 + 9438 O -10.619435 15.949865 1.585511 402 9439 9440 + 9439 H -10.621509 15.567618 2.491670 403 9438 + 9440 H -10.362619 16.916267 1.609401 403 9438 + 9441 O -1.101917 -7.441924 10.586362 402 9442 9443 + 9442 H -0.567999 -7.634893 11.314871 403 9441 + 9443 H -0.711206 -6.670438 10.158382 403 9441 + 9444 O -8.851165 -9.058377 -8.388886 402 9445 9446 + 9445 H -9.044805 -8.277288 -8.905613 403 9444 + 9446 H -7.947771 -9.334823 -8.625881 403 9444 + 9447 O -12.865173 -20.003868 -17.685004 402 9448 9449 + 9448 H -11.900331 -20.290871 -17.648188 403 9447 + 9449 H -13.259242 -20.215643 -16.805809 403 9447 + 9450 O 8.134636 3.904853 11.647104 402 9451 9452 + 9451 H 7.339621 4.198944 12.086138 403 9450 + 9452 H 8.359181 3.015108 11.941173 403 9450 + 9453 O 19.642179 -0.232387 9.832126 402 9454 9455 + 9454 H 18.865134 -0.769467 9.662648 403 9453 + 9455 H 19.348750 0.264237 10.621214 403 9453 + 9456 O -12.682747 8.424040 -10.230134 402 9457 9458 + 9457 H -13.551445 8.389330 -9.854912 403 9456 + 9458 H -12.463391 9.379389 -10.339605 403 9456 + 9459 O 26.914440 16.154997 -16.554272 402 9460 9461 + 9460 H 26.893167 15.808906 -17.482437 403 9459 + 9461 H 26.594368 15.442541 -16.021243 403 9459 + 9462 O -6.756073 6.486074 12.621266 402 9463 9464 + 9463 H -6.001614 6.299854 12.037502 403 9462 + 9464 H -7.537856 6.154367 12.136267 403 9462 + 9465 O -1.534934 -0.378729 -11.255488 402 9466 9467 + 9466 H -1.019268 -0.077205 -12.015010 403 9465 + 9467 H -1.396223 0.199493 -10.524178 403 9465 + 9468 O -7.913402 -19.479583 -10.101731 402 9469 9470 + 9469 H -7.094305 -19.451963 -10.661033 403 9468 + 9470 H -8.430321 -18.659348 -10.306663 403 9468 + 9471 O 19.510276 5.438180 15.252043 402 9472 9473 + 9472 H 19.984510 4.581515 15.209276 403 9471 + 9473 H 18.693891 5.265727 15.619608 403 9471 + 9474 O 14.672317 -11.674219 -8.512325 402 9475 9476 + 9475 H 15.214654 -10.997268 -8.992741 403 9474 + 9476 H 15.271629 -12.444207 -8.537082 403 9474 + 9477 O -26.549973 -17.678593 10.402834 402 9478 9479 + 9478 H -25.763998 -17.483834 10.878590 403 9477 + 9479 H -27.160376 -17.361462 11.034196 403 9477 + 9480 O 5.271179 14.438724 -17.415549 402 9481 9482 + 9481 H 4.435936 14.151626 -17.136425 403 9480 + 9482 H 5.468504 14.023544 -18.253894 403 9480 + 9483 O 26.352424 19.290788 19.181784 402 9484 9485 + 9484 H 26.638793 20.134863 19.511609 403 9483 + 9485 H 27.096123 18.959221 18.597699 403 9483 + 9486 O -26.414188 7.441925 13.185744 402 9487 9488 + 9487 H -26.562431 6.574296 12.885418 403 9486 + 9488 H -25.860420 7.846130 12.499402 403 9486 + 9489 O 5.368816 -14.762666 -4.864027 402 9490 9491 + 9490 H 6.085752 -14.950510 -4.202359 403 9489 + 9491 H 5.366848 -13.815827 -5.050153 403 9489 + 9492 O -1.852223 13.402453 16.099559 402 9493 9494 + 9493 H -0.907053 13.096616 15.950410 403 9492 + 9494 H -2.405269 12.678324 16.442150 403 9492 + 9495 O -9.537989 1.018888 -17.294635 402 9496 9497 + 9496 H -10.174283 0.989703 -18.011766 403 9495 + 9497 H -10.088090 0.844105 -16.509242 403 9495 + 9498 O -4.825860 2.375466 13.925597 402 9499 9500 + 9499 H -4.190822 2.787671 13.323831 403 9498 + 9500 H -5.515449 3.033395 14.087300 403 9498 + 9501 O 19.580327 -10.893880 -2.747248 402 9502 9503 + 9502 H 19.742431 -11.614878 -3.428406 403 9501 + 9503 H 18.622372 -10.972265 -2.491828 403 9501 + 9504 O 19.256086 14.705134 10.874402 402 9505 9506 + 9505 H 20.041175 14.096992 10.573737 403 9504 + 9506 H 18.760180 14.026878 11.366191 403 9504 + 9507 O 4.455935 -2.361452 20.137505 402 9508 9509 + 9508 H 3.955764 -1.509452 20.278229 403 9507 + 9509 H 4.874829 -2.603490 21.001857 403 9507 + 9510 O -25.974850 13.344171 -18.000007 402 9511 9512 + 9511 H -26.267499 12.457368 -18.163639 403 9510 + 9512 H -26.149308 13.539735 -17.037715 403 9510 + 9513 O 17.067973 2.763490 17.660244 402 9514 9515 + 9514 H 16.915215 3.437471 16.973312 403 9513 + 9515 H 17.816632 2.203161 17.314923 403 9513 + 9516 O -11.517545 18.040646 17.714435 402 9517 9518 + 9517 H -11.560942 17.052444 17.749537 403 9516 + 9518 H -11.413962 18.230547 18.657315 403 9516 + 9519 O 25.776483 -1.160860 1.258340 402 9520 9521 + 9520 H 26.324116 -0.766625 1.925968 403 9519 + 9521 H 25.733053 -0.545865 0.469204 403 9519 + 9522 O 0.465549 -19.018322 6.222139 402 9523 9524 + 9523 H 0.971697 -19.764727 5.842403 403 9522 + 9524 H 1.099427 -18.538006 6.759456 403 9522 + 9525 O 26.241049 -6.898960 18.643166 402 9526 9527 + 9526 H 25.947101 -5.963940 18.676752 403 9525 + 9527 H 25.610721 -7.314304 19.228579 403 9525 + 9528 O 16.134037 -10.035813 7.553052 402 9529 9530 + 9529 H 16.959970 -10.575559 7.222214 403 9528 + 9530 H 16.256703 -9.244050 7.026849 403 9528 + 9531 O 22.936475 16.842438 -13.354400 402 9532 9533 + 9532 H 23.113117 16.122413 -13.952998 403 9531 + 9533 H 22.167217 17.380611 -13.705166 403 9531 + 9534 O -6.174635 -12.567358 -9.759225 402 9535 9536 + 9535 H -7.056186 -12.732423 -10.081695 403 9534 + 9536 H -6.114005 -12.989145 -8.857709 403 9534 + 9537 O 13.127494 -17.049020 5.559108 402 9538 9539 + 9538 H 12.909499 -17.802411 4.984143 403 9537 + 9539 H 12.442780 -16.360937 5.316305 403 9537 + 9540 O 10.969996 20.716828 15.837969 402 9541 9542 + 9541 H 10.927306 20.477406 14.883647 403 9540 + 9542 H 11.840696 20.306837 16.078361 403 9540 + 9543 O 13.866770 18.367517 6.937702 402 9544 9545 + 9544 H 13.986130 19.326827 7.078015 403 9543 + 9545 H 14.231164 17.993652 7.716184 403 9543 + 9546 O 13.832788 12.943646 -11.273375 402 9547 9548 + 9547 H 14.056108 12.521321 -12.121074 403 9546 + 9548 H 13.085693 12.513389 -10.836623 403 9546 + 9549 O 17.127641 6.332315 -10.642348 402 9550 9551 + 9550 H 16.719396 7.195424 -10.818370 403 9549 + 9551 H 16.487151 5.750510 -10.856669 403 9549 + 9552 O 7.636882 -18.482195 20.548956 402 9553 9554 + 9553 H 7.346233 -18.787052 19.666640 403 9552 + 9554 H 8.040956 -17.608352 20.385186 403 9552 + 9555 O 15.587474 -5.247845 -16.278347 402 9556 9557 + 9556 H 16.572338 -5.288530 -16.165720 403 9555 + 9557 H 15.545571 -4.364820 -16.698452 403 9555 + 9558 O 0.738994 10.421255 -19.729083 402 9559 9560 + 9559 H 0.031346 10.313580 -20.434784 403 9558 + 9560 H 0.614162 9.625359 -19.156085 403 9558 + 9561 O -21.514700 17.398643 -8.313387 402 9562 9563 + 9562 H -21.261038 18.368357 -8.523940 403 9561 + 9563 H -20.879597 16.869528 -8.849738 403 9561 + 9564 O 21.659354 19.006928 20.763229 402 9565 9566 + 9565 H 22.346807 19.674088 20.960616 403 9564 + 9566 H 22.147607 18.139994 20.600269 403 9564 + 9567 O -13.226723 20.003033 16.874806 402 9568 9569 + 9568 H -12.786621 19.156341 16.987387 403 9567 + 9569 H -13.521849 20.036703 15.939938 403 9567 + 9570 O 12.035825 14.976596 17.699907 402 9571 9572 + 9571 H 11.299148 14.549820 17.199522 403 9570 + 9572 H 12.476396 14.244702 18.105024 403 9570 + 9573 O 23.014725 11.421066 -1.195826 402 9574 9575 + 9574 H 22.935852 12.296840 -0.719881 403 9573 + 9575 H 23.315744 11.556530 -2.052974 403 9573 + 9576 O 21.005599 -13.607746 -17.329690 402 9577 9578 + 9577 H 20.264961 -13.783556 -16.739494 403 9576 + 9578 H 21.692829 -14.155085 -17.164895 403 9576 + 9579 O 19.390018 13.715877 -9.986126 402 9580 9581 + 9580 H 18.766137 13.984667 -10.642161 403 9579 + 9581 H 18.882708 13.584906 -9.182021 403 9579 + 9582 O 21.591458 2.844658 -17.196608 402 9583 9584 + 9583 H 21.687177 3.186923 -18.110216 403 9582 + 9584 H 22.488513 2.580610 -17.004967 403 9582 + 9585 O 11.345787 -11.914521 18.833564 402 9586 9587 + 9586 H 10.571637 -11.320431 18.801840 403 9585 + 9587 H 11.974322 -11.433977 19.432443 403 9585 + 9588 O 14.649482 -19.545223 8.356804 402 9589 9590 + 9589 H 14.003078 -18.851322 8.539351 403 9588 + 9590 H 15.599308 -19.149367 8.338570 403 9588 + 9591 O -11.043193 -18.255867 17.281239 402 9592 9593 + 9592 H -10.224926 -18.639865 16.994545 403 9591 + 9593 H -11.487164 -19.009987 17.634582 403 9591 + 9594 O -26.985345 -16.412246 -14.400881 402 9595 9596 + 9595 H -27.454047 -15.606813 -14.379952 403 9594 + 9596 H -26.081841 -16.159237 -14.585861 403 9594 + 9597 O 19.102051 -15.098666 -8.764412 402 9598 9599 + 9598 H 19.000932 -15.521094 -9.678404 403 9597 + 9599 H 19.453733 -14.174347 -8.910357 403 9597 + 9600 O 6.376012 19.349948 5.671135 402 9601 9602 + 9601 H 6.687862 20.029372 5.077314 403 9600 + 9602 H 5.561947 19.709229 6.038539 403 9600 + 9603 O -17.499998 -13.507016 9.684050 402 9604 9605 + 9604 H -17.138230 -13.962493 10.435127 403 9603 + 9605 H -17.640659 -14.284861 9.096248 403 9603 + 9606 O 17.699807 -14.814698 11.789809 402 9607 9608 + 9607 H 17.014114 -15.422000 11.369433 403 9606 + 9608 H 17.429825 -14.840034 12.737607 403 9606 + 9609 O 12.888820 1.939624 -17.757092 402 9610 9611 + 9610 H 12.023501 2.459281 -17.778689 403 9609 + 9611 H 12.922205 1.789197 -16.837552 403 9609 + 9612 O -27.142428 -4.791675 -8.608453 402 9613 9614 + 9613 H -27.117499 -4.179414 -9.373351 403 9612 + 9614 H -26.563163 -5.561210 -8.869517 403 9612 + 9615 O 18.673615 12.370651 6.319082 402 9616 9617 + 9616 H 18.699459 11.385010 6.253835 403 9615 + 9617 H 18.583561 12.688817 5.434396 403 9615 + 9618 O 10.178364 -12.605036 -17.136500 402 9619 9620 + 9619 H 10.699128 -12.924478 -16.370473 403 9618 + 9620 H 9.489391 -13.311993 -17.195335 403 9618 + 9621 O 7.257958 3.289333 16.273726 402 9622 9623 + 9622 H 7.801701 4.023865 16.654114 403 9621 + 9623 H 6.831954 2.726700 16.945762 403 9621 + 9624 O -22.793525 -4.351149 1.112435 402 9625 9626 + 9625 H -23.178683 -4.998212 1.686297 403 9624 + 9626 H -22.676437 -3.490820 1.495852 403 9624 + 9627 O 10.431915 10.150385 6.416596 402 9628 9629 + 9628 H 9.504032 10.369808 6.525826 403 9627 + 9629 H 10.818627 10.534325 7.222492 403 9627 + 9630 O 16.181318 -18.659361 -4.530126 402 9631 9632 + 9631 H 16.539581 -18.491898 -3.640666 403 9630 + 9632 H 16.723714 -18.083763 -5.128977 403 9630 + 9633 O 24.085884 14.331318 -5.367949 402 9634 9635 + 9634 H 25.027794 14.190212 -5.345575 403 9633 + 9635 H 23.725489 13.957121 -4.548465 403 9633 + 9636 O 27.476267 18.553177 -13.120949 402 9637 9638 + 9637 H 27.278972 18.193548 -12.233661 403 9636 + 9638 H 26.663894 18.473337 -13.667172 403 9636 + 9639 O -3.429941 10.490939 1.565767 402 9640 9641 + 9640 H -4.189571 9.996973 1.988486 403 9639 + 9641 H -2.756994 10.462029 2.200444 403 9639 + 9642 O -23.874077 -2.287625 -14.406474 402 9643 9644 + 9643 H -24.326434 -2.528790 -13.612508 403 9642 + 9644 H -23.725821 -1.349091 -14.150316 403 9642 + 9645 O 6.913124 -5.939231 14.325196 402 9646 9647 + 9646 H 7.603991 -5.675852 13.760866 403 9645 + 9647 H 7.141094 -6.840164 14.586103 403 9645 + 9648 O -9.435672 7.567999 -12.736311 402 9649 9650 + 9649 H -10.092450 7.532344 -13.480723 403 9648 + 9650 H -9.904849 7.166688 -11.970693 403 9648 + 9651 O -23.627772 20.561997 -10.291642 402 9652 9653 + 9652 H -23.140188 21.403417 -10.120507 403 9651 + 9653 H -23.127330 19.939171 -10.860601 403 9651 + 9654 O -11.957151 -10.758767 10.380421 402 9655 9656 + 9655 H -12.914975 -11.025570 10.474104 403 9654 + 9656 H -11.726864 -10.328942 11.254768 403 9654 + 9657 O -4.055025 -16.357375 12.638110 402 9658 9659 + 9658 H -4.145602 -15.539307 12.188903 403 9657 + 9659 H -3.229424 -16.754351 12.492730 403 9657 + 9660 O -25.660951 2.977355 3.644209 402 9661 9662 + 9661 H -25.405729 3.847728 3.825406 403 9660 + 9662 H -26.592530 3.015138 3.572516 403 9660 + 9663 O -1.059386 -9.814838 20.360215 402 9664 9665 + 9664 H -0.131280 -9.654603 20.258879 403 9663 + 9665 H -1.404044 -10.175480 19.521783 403 9663 + 9666 O -13.274409 -12.355600 6.487680 402 9667 9668 + 9667 H -14.175655 -12.374044 6.195808 403 9666 + 9668 H -12.869043 -11.626070 5.932127 403 9666 + 9669 O -17.154642 -17.337539 -2.602671 402 9670 9671 + 9670 H -17.684268 -17.711860 -3.323318 403 9669 + 9671 H -17.542126 -17.638492 -1.768263 403 9669 + 9672 O -8.431986 -14.331490 -18.620988 402 9673 9674 + 9673 H -8.525378 -14.518157 -17.652352 403 9672 + 9674 H -9.070115 -15.091242 -18.962501 403 9672 + 9675 O 9.227734 -14.707755 8.334683 402 9676 9677 + 9676 H 8.912750 -14.297078 9.180099 403 9675 + 9677 H 10.141362 -14.864367 8.460368 403 9675 + 9678 O -18.940927 -7.749229 13.986681 402 9679 9680 + 9679 H -18.998677 -8.736236 14.046068 403 9678 + 9680 H -18.235160 -7.570709 13.352401 403 9678 + 9681 O -3.315848 14.486693 12.321029 402 9682 9683 + 9682 H -2.891118 14.428375 11.433488 403 9681 + 9683 H -3.009257 15.355409 12.649294 403 9681 + 9684 O 15.258302 19.640916 -9.495586 402 9685 9686 + 9685 H 15.255790 19.268774 -10.417780 403 9684 + 9686 H 14.362167 19.825595 -9.329840 403 9684 + 9687 O -27.308827 -17.253050 -3.549375 402 9688 9689 + 9688 H -27.016406 -16.762829 -2.812626 403 9687 + 9689 H -26.618283 -17.291456 -4.216078 403 9687 + 9690 O -17.469474 9.268976 13.624133 402 9691 9692 + 9691 H -17.003981 8.734120 14.281842 403 9690 + 9692 H -17.567961 10.133200 14.047196 403 9690 + 9693 O 20.896249 -8.668059 -15.648620 402 9694 9695 + 9694 H 21.320419 -8.468808 -14.797523 403 9693 + 9695 H 20.936901 -9.602395 -15.783740 403 9693 + 9696 O 6.591038 13.945476 -6.677072 402 9697 9698 + 9697 H 6.387452 12.989743 -6.664344 403 9696 + 9698 H 7.535066 14.092588 -6.670539 403 9696 + 9699 O 10.072634 7.484666 6.879205 402 9700 9701 + 9700 H 9.218040 7.159172 6.564500 403 9699 + 9701 H 10.122197 8.421774 6.591601 403 9699 + 9702 O -23.792275 5.951536 11.433857 402 9703 9704 + 9703 H -23.560372 6.167334 12.401775 403 9702 + 9704 H -23.076924 6.327786 10.856454 403 9702 + 9705 O 12.132840 3.851033 -6.616749 402 9706 9707 + 9706 H 12.785083 4.216573 -7.191058 403 9705 + 9707 H 12.512257 3.897859 -5.719717 403 9705 + 9708 O 5.351683 6.078049 -14.255102 402 9709 9710 + 9709 H 5.013358 6.855687 -13.813494 403 9708 + 9710 H 5.137704 6.252225 -15.124513 403 9708 + 9711 O 13.138157 -8.336001 1.684188 402 9712 9713 + 9712 H 12.595335 -8.813255 1.081700 403 9711 + 9713 H 13.382247 -7.459796 1.264391 403 9711 + 9714 O -10.347292 10.399621 -12.874082 402 9715 9716 + 9715 H -10.494653 9.452942 -12.814808 403 9714 + 9716 H -10.828227 10.775518 -13.651328 403 9714 + 9717 O 9.152946 -17.315622 6.377534 402 9718 9719 + 9718 H 8.873272 -17.655423 5.536131 403 9717 + 9719 H 9.644625 -16.466151 6.247065 403 9717 + 9720 O -2.422355 -14.638070 -20.255326 402 9721 9722 + 9721 H -2.466677 -15.603006 -20.125891 403 9720 + 9722 H -2.234204 -14.630853 -21.192244 403 9720 + 9723 O 7.306601 16.960372 -8.356338 402 9724 9725 + 9724 H 7.335426 17.713766 -8.966973 403 9723 + 9725 H 6.389385 16.681622 -8.314986 403 9723 + 9726 O -11.068015 -16.691381 7.975224 402 9727 9728 + 9727 H -11.725330 -17.098102 8.584468 403 9726 + 9728 H -11.554703 -15.995305 7.530686 403 9726 + 9729 O 2.086903 -14.793471 13.604939 402 9730 9731 + 9730 H 2.196059 -15.680487 13.948768 403 9729 + 9731 H 2.568411 -14.755595 12.759739 403 9729 + 9732 O -17.658207 18.277094 2.186303 402 9733 9734 + 9733 H -17.424686 17.674490 1.472227 403 9732 + 9734 H -18.244002 18.909136 1.776504 403 9732 + 9735 O 24.999903 10.057013 0.434977 402 9736 9737 + 9736 H 24.330807 10.404778 -0.199378 403 9735 + 9737 H 24.595385 9.375992 1.021837 403 9735 diff --git a/examples/amoeba/water_box.xyz b/examples/amoeba/water_box.xyz new file mode 100644 index 0000000000..0936f51b41 --- /dev/null +++ b/examples/amoeba/water_box.xyz @@ -0,0 +1,649 @@ + 648 Water Cubic Box (18.643 Ang, 216 AMOEBA) + 1 O 8.679662 7.087692 -0.696862 1 2 3 + 2 H 7.809455 6.755792 -0.382259 2 1 + 3 H 8.722232 6.814243 -1.617561 2 1 + 4 O -0.117313 8.244447 6.837616 1 5 6 + 5 H 0.216892 7.895445 6.050027 2 4 + 6 H 0.444268 7.826013 7.530196 2 4 + 7 O 8.379057 -0.092611 6.814631 1 8 9 + 8 H 9.340423 0.098069 6.734062 2 7 + 9 H 7.939619 0.573676 6.269838 2 7 + 10 O 6.589952 1.844323 -6.923167 1 11 12 + 11 H 5.885429 2.402305 -6.717934 2 10 + 12 H 6.181533 1.062747 -7.273678 2 10 + 13 O 7.146600 5.753582 2.331517 1 14 15 + 14 H 6.368123 6.126035 2.862678 2 13 + 15 H 7.025018 6.294645 1.518196 2 13 + 16 O -2.426581 -8.504195 -2.504834 1 17 18 + 17 H -1.692063 -8.368252 -3.058292 2 16 + 18 H -2.793207 -7.602469 -2.403097 2 16 + 19 O -8.038375 -3.605589 2.303691 1 20 21 + 20 H -8.113753 -4.248127 3.018494 2 19 + 21 H -7.619392 -2.863004 2.709622 2 19 + 22 O -1.480631 8.244085 -8.272215 1 23 24 + 23 H -2.090204 8.687978 -7.676996 2 22 + 24 H -0.700878 8.823325 -8.322213 2 22 + 25 O -3.741962 -2.777830 -2.326319 1 26 27 + 26 H -4.620456 -2.444778 -2.390519 2 25 + 27 H -3.728921 -3.160952 -1.433101 2 25 + 28 O -6.467812 -5.265942 0.408263 1 29 30 + 29 H -6.585076 -4.796537 -0.413008 2 28 + 30 H -7.021252 -4.752640 1.007958 2 28 + 31 O 9.273577 5.342431 4.055460 1 32 33 + 32 H 8.645939 5.466500 4.837640 2 31 + 33 H 8.741774 5.686149 3.302820 2 31 + 34 O 1.830160 4.276731 -6.993499 1 35 36 + 35 H 1.703275 5.223773 -6.703852 2 34 + 36 H 2.408113 3.853447 -6.383339 2 34 + 37 O 1.964382 6.832988 8.373101 1 38 39 + 38 H 2.496135 7.215781 9.056298 2 37 + 39 H 1.811283 5.905846 8.573539 2 37 + 40 O 5.405568 4.388994 7.932737 1 41 42 + 41 H 5.537380 3.438955 7.781311 2 40 + 42 H 4.755156 4.734908 7.290617 2 40 + 43 O 3.229998 2.928417 -1.090650 1 44 45 + 44 H 3.931090 3.198265 -1.702769 2 43 + 45 H 3.004438 3.708969 -0.493266 2 43 + 46 O 7.462400 5.262829 6.131170 1 47 48 + 47 H 8.025650 5.588493 6.881770 2 46 + 48 H 6.935076 4.455766 6.325405 2 46 + 49 O -8.864042 7.023845 -6.659632 1 50 51 + 50 H -8.370939 6.372557 -7.141895 2 49 + 51 H -9.489800 7.315873 -7.293125 2 49 + 52 O -4.526299 3.549989 8.030031 1 53 54 + 53 H -5.169770 4.224127 7.731323 2 52 + 54 H -4.262096 3.801892 8.884875 2 52 + 55 O 4.823286 -1.386218 4.038464 1 56 57 + 56 H 5.493155 -0.669965 4.013081 2 55 + 57 H 4.187463 -1.101832 3.338433 2 55 + 58 O -2.151150 -2.017060 -8.593685 1 59 60 + 59 H -2.475709 -2.320356 -7.783564 2 58 + 60 H -2.650484 -2.434614 -9.307384 2 58 + 61 O 1.944893 4.933226 0.497910 1 62 63 + 62 H 2.553221 5.263352 1.205303 2 61 + 63 H 2.082534 5.590999 -0.202171 2 61 + 64 O -6.827006 -5.285917 -2.371899 1 65 66 + 65 H -7.405873 -6.022738 -2.075913 2 64 + 66 H -6.398443 -5.453726 -3.235054 2 64 + 67 O -8.538047 -7.577917 -1.688532 1 68 69 + 68 H -8.075591 -8.448260 -1.513455 2 67 + 69 H -9.389507 -7.836271 -2.051835 2 67 + 70 O -6.916556 -1.100882 -5.168782 1 71 72 + 71 H -6.365888 -1.659366 -5.746210 2 70 + 72 H -6.538885 -0.249374 -5.325993 2 70 + 73 O 6.330290 -9.323893 -6.416630 1 74 75 + 74 H 7.026026 -9.680578 -7.007727 2 73 + 75 H 6.812488 -8.683594 -5.925799 2 73 + 76 O -2.424345 -5.918126 2.701855 1 77 78 + 77 H -1.613829 -5.486394 2.503024 2 76 + 78 H -3.144797 -5.307275 2.618121 2 76 + 79 O 0.637202 -6.080457 5.849135 1 80 81 + 80 H 0.892312 -6.092342 4.907709 2 79 + 81 H -0.339074 -5.838972 5.853292 2 79 + 82 O 5.199216 -2.264918 -0.138343 1 83 84 + 83 H 5.802838 -2.788698 -0.697536 2 82 + 84 H 5.670340 -1.679393 0.462296 2 82 + 85 O 0.510145 7.629450 4.054500 1 86 87 + 86 H -0.071135 8.146563 3.452959 2 85 + 87 H 1.464962 7.740819 3.669172 2 85 + 88 O 3.146724 8.895843 6.526257 1 89 90 + 89 H 3.506091 8.599906 7.352942 2 88 + 90 H 2.145729 8.929622 6.682029 2 88 + 91 O 7.308541 -8.339335 -2.471342 1 92 93 + 92 H 6.562127 -8.180601 -3.062803 2 91 + 93 H 6.993025 -8.364954 -1.531235 2 91 + 94 O -7.530792 1.069683 4.989387 1 95 96 + 95 H -7.565406 1.971422 4.648636 2 94 + 96 H -7.938250 0.433547 4.370266 2 94 + 97 O 4.452035 2.700609 -5.437815 1 98 99 + 98 H 4.603326 3.058652 -4.551590 2 97 + 99 H 4.386453 1.737004 -5.180419 2 97 + 100 O 8.427922 -8.619286 1.784691 1 101 102 + 101 H 8.340498 -8.005342 2.536225 2 100 + 102 H 8.496720 -9.530562 2.174667 2 100 + 103 O -8.109456 1.753830 -3.096997 1 104 105 + 104 H -7.245287 1.827177 -2.721417 2 103 + 105 H -8.082178 1.783171 -4.059329 2 103 + 106 O 2.776933 -5.701955 7.748213 1 107 108 + 107 H 3.287974 -5.069688 7.233816 2 106 + 108 H 1.987041 -5.817355 7.200131 2 106 + 109 O 3.635171 -6.953519 5.339628 1 110 111 + 110 H 3.353851 -7.592789 6.031367 2 109 + 111 H 2.875801 -6.787975 4.740576 2 109 + 112 O 6.888027 -4.169023 -1.800190 1 113 114 + 113 H 7.559735 -4.813701 -2.004669 2 112 + 114 H 6.603805 -3.759237 -2.626496 2 112 + 115 O -4.470837 -4.105640 3.415362 1 116 117 + 116 H -4.991607 -3.358538 3.140956 2 115 + 117 H -4.791764 -4.392214 4.254387 2 115 + 118 O 8.282263 -0.462068 -2.560579 1 119 120 + 119 H 8.776769 -1.293641 -2.335945 2 118 + 120 H 8.760297 0.384816 -2.651128 2 118 + 121 O 4.737236 1.616430 4.901115 1 122 123 + 122 H 3.969692 2.168368 5.152631 2 121 + 123 H 5.184651 2.148403 4.154746 2 121 + 124 O -3.497332 -5.781436 -2.202713 1 125 126 + 125 H -4.038857 -5.773824 -1.381680 2 124 + 126 H -4.152970 -6.012265 -2.829379 2 124 + 127 O -2.863989 -0.259334 -1.857006 1 128 129 + 128 H -2.132201 -0.027953 -1.174211 2 127 + 129 H -2.873625 -1.224425 -1.874253 2 127 + 130 O 1.138300 1.133100 -2.085899 1 131 132 + 131 H 1.965506 1.503520 -1.725316 2 130 + 132 H 0.420521 1.534440 -1.551356 2 130 + 133 O -0.561328 4.590705 -2.780017 1 134 135 + 134 H -0.061173 3.919356 -3.294128 2 133 + 135 H -0.082763 4.733898 -1.955602 2 133 + 136 O -6.423002 -1.705204 -2.528225 1 137 138 + 137 H -7.233989 -1.949552 -1.975418 2 136 + 138 H -6.678416 -1.321413 -3.351278 2 136 + 139 O -2.772100 2.552210 -0.672282 1 140 141 + 140 H -2.907489 3.483552 -0.385605 2 139 + 141 H -2.977127 2.592348 -1.635820 2 139 + 142 O 6.708678 -4.852016 -8.379280 1 143 144 + 143 H 6.593474 -5.094964 -7.447187 2 142 + 144 H 6.582524 -5.591596 -8.966502 2 142 + 145 O -8.497001 -0.440284 2.803721 1 146 147 + 146 H -8.422350 0.331961 2.183451 2 145 + 147 H -9.377295 -0.756160 2.677026 2 145 + 148 O 2.975383 -0.894970 6.060783 1 149 150 + 149 H 2.093991 -0.995700 5.670129 2 148 + 150 H 3.458832 -0.759248 5.263958 2 148 + 151 O -6.085023 -1.629620 7.970284 1 152 153 + 152 H -6.685848 -2.391830 7.820849 2 151 + 153 H -6.177296 -1.190584 8.835912 2 151 + 154 O -3.763523 -3.356777 8.285436 1 155 156 + 155 H -4.660650 -3.029414 8.406662 2 154 + 156 H -3.411834 -3.178947 7.431180 2 154 + 157 O -1.100120 -0.320162 0.375372 1 158 159 + 158 H -0.527013 -1.012183 0.128652 2 157 + 159 H -0.673226 0.288559 0.934677 2 157 + 160 O 0.910209 -8.271802 1.411429 1 161 162 + 161 H 0.158544 -8.759532 1.870895 2 160 + 162 H 0.565924 -7.546113 0.944383 2 160 + 163 O 1.554065 -6.468033 3.310872 1 164 165 + 164 H 1.362455 -7.162802 2.722340 2 163 + 165 H 1.616233 -5.622409 2.872854 2 163 + 166 O 0.543127 -1.388652 4.886094 1 167 168 + 167 H 0.110320 -0.665826 5.311239 2 166 + 168 H 0.420366 -2.216367 5.267301 2 166 + 169 O 1.100526 1.019490 -9.255318 1 170 171 + 170 H 1.460815 0.575286 -8.484128 2 169 + 171 H 0.265613 0.594128 -9.297750 2 169 + 172 O -1.842348 2.327827 -5.355326 1 173 174 + 173 H -1.572941 2.573139 -6.288125 2 172 + 174 H -2.216679 1.439934 -5.361006 2 172 + 175 O 2.452307 -2.814686 -6.448759 1 176 177 + 176 H 2.862295 -3.091668 -5.589336 2 175 + 177 H 2.913920 -3.262923 -7.181510 2 175 + 178 O -2.207998 -3.112007 5.945795 1 179 180 + 179 H -1.262203 -3.125339 6.205467 2 178 + 180 H -2.228269 -2.421858 5.220629 2 178 + 181 O 5.845471 5.020556 -6.836491 1 182 183 + 182 H 5.557986 5.913737 -6.753889 2 181 + 183 H 5.089998 4.459153 -6.661079 2 181 + 184 O -3.421643 4.865553 0.731755 1 185 186 + 185 H -3.965419 4.458452 1.478214 2 184 + 186 H -3.973445 4.958338 -0.044430 2 184 + 187 O -2.302950 -2.349717 2.112168 1 188 189 + 188 H -2.576438 -1.873492 2.873191 2 187 + 189 H -1.882868 -1.715106 1.503782 2 187 + 190 O 0.305885 4.878766 3.791182 1 191 192 + 191 H 0.299338 5.855407 4.097578 2 190 + 192 H 1.169911 4.563497 4.030616 2 190 + 193 O 2.925008 -3.664845 -3.607450 1 194 195 + 194 H 3.015896 -3.916618 -2.644267 2 193 + 195 H 2.353923 -2.889459 -3.518284 2 193 + 196 O 1.111505 -4.070255 -9.085693 1 197 198 + 197 H 2.084905 -4.227348 -9.180249 2 196 + 198 H 0.897072 -4.902218 -8.740523 2 196 + 199 O -4.992929 -1.974219 -7.099668 1 200 201 + 200 H -5.173269 -1.186309 -7.673625 2 199 + 201 H -5.070893 -2.753273 -7.658821 2 199 + 202 O 4.730983 1.478420 0.720986 1 203 204 + 203 H 4.271686 1.988265 0.034225 2 202 + 204 H 4.117413 0.788607 1.061818 2 202 + 205 O 1.421583 -0.176666 -6.729105 1 206 207 + 206 H 1.217660 0.394331 -5.978213 2 205 + 207 H 1.948444 -0.877988 -6.400659 2 205 + 208 O -7.093223 -8.541193 4.116187 1 209 210 + 209 H -7.074252 -8.047477 3.242159 2 208 + 210 H -6.153142 -8.537148 4.455550 2 208 + 211 O 8.382540 -6.460958 3.765735 1 212 213 + 212 H 9.258625 -6.141972 4.060763 2 211 + 213 H 7.637364 -6.217910 4.407852 2 211 + 214 O -4.320241 4.037137 3.297092 1 215 216 + 215 H -3.750151 4.141786 4.105470 2 214 + 216 H -5.172925 4.455578 3.488906 2 214 + 217 O 5.581877 1.781994 7.505132 1 218 219 + 218 H 5.017196 1.139584 8.120950 2 217 + 219 H 5.330781 1.591217 6.595286 2 217 + 220 O -0.734443 1.125031 4.884666 1 221 222 + 221 H -0.239224 1.540322 4.142070 2 220 + 222 H -0.961628 1.783437 5.554548 2 220 + 223 O 6.831005 -9.249970 4.497165 1 224 225 + 224 H 6.836746 -9.068011 5.427146 2 223 + 225 H 7.668067 -9.652510 4.249957 2 223 + 226 O 2.714055 -3.677581 1.962003 1 227 228 + 227 H 3.333432 -3.851775 2.663540 2 226 + 228 H 3.095021 -3.978526 1.102566 2 226 + 229 O -1.364034 -5.762724 -5.514747 1 230 231 + 230 H -2.238584 -5.409106 -5.314718 2 229 + 231 H -0.948185 -4.908428 -5.559580 2 229 + 232 O -3.623435 -8.061229 1.383141 1 233 234 + 233 H -3.132847 -7.446722 1.857906 2 232 + 234 H -4.307943 -7.546630 0.933298 2 232 + 235 O 5.717894 6.958376 4.528556 1 236 237 + 236 H 5.852657 7.879846 4.341790 2 235 + 237 H 6.443636 6.708413 5.135144 2 235 + 238 O 8.121415 8.262619 -8.483986 1 239 240 + 239 H 8.585190 8.939651 -8.974230 2 238 + 240 H 7.560207 7.748539 -9.044644 2 238 + 241 O -5.111889 -0.352865 5.807903 1 242 243 + 242 H -5.940048 0.102298 5.569630 2 241 + 243 H -5.349104 -1.014090 6.507582 2 241 + 244 O 0.327324 2.563438 0.113251 1 245 246 + 245 H -0.633994 2.522136 -0.069385 2 244 + 246 H 0.724331 3.482989 0.160564 2 244 + 247 O -6.003367 -7.683112 -8.874252 1 248 249 + 248 H -6.987751 -7.912403 -8.892689 2 247 + 249 H -5.699015 -8.504722 -8.558813 2 247 + 250 O 0.789377 -6.357883 -7.563043 1 251 252 + 251 H -0.151101 -6.341313 -7.440906 2 250 + 252 H 1.090881 -5.879281 -6.770796 2 250 + 253 O 5.045666 7.219298 -5.151826 1 254 255 + 254 H 5.598994 7.846492 -5.618276 2 253 + 255 H 5.480466 6.978976 -4.337211 2 253 + 256 O 1.286092 6.990271 -6.806004 1 257 258 + 257 H 0.481329 7.140371 -7.345224 2 256 + 258 H 1.716012 7.791024 -6.762706 2 256 + 259 O -3.198783 -9.175883 -6.334156 1 260 261 + 260 H -3.032721 -8.198157 -6.198635 2 259 + 261 H -3.084774 -9.539992 -5.434969 2 259 + 262 O -2.002554 -5.668583 5.440781 1 263 264 + 263 H -2.347493 -4.756386 5.542471 2 262 + 264 H -2.133027 -6.049986 4.540349 2 262 + 265 O 6.174952 -8.574733 0.210584 1 266 267 + 266 H 5.358389 -8.191902 0.557392 2 265 + 267 H 6.760918 -8.561710 0.943985 2 265 + 268 O -6.278610 6.057339 4.042358 1 269 270 + 269 H -6.169211 6.708022 3.383078 2 268 + 270 H -7.221766 5.771239 4.032205 2 268 + 271 O 0.124733 -5.816398 0.203961 1 272 273 + 272 H 0.029974 -5.049468 0.786871 2 271 + 273 H -0.458026 -5.646677 -0.555312 2 271 + 274 O 3.839311 -0.064469 8.619720 1 275 276 + 275 H 3.586253 -0.282978 7.705313 2 274 + 276 H 3.079936 0.282626 9.065559 2 274 + 277 O 7.375986 -1.368885 4.452411 1 278 279 + 278 H 8.024931 -0.682735 4.768078 2 277 + 279 H 7.477247 -1.279372 3.493009 2 277 + 280 O 9.209092 -1.611532 -6.423337 1 281 282 + 281 H 9.487648 -2.470973 -6.800897 2 280 + 282 H 9.998917 -1.354277 -5.866779 2 280 + 283 O -5.314625 -5.613762 7.941745 1 284 285 + 284 H -5.589748 -6.389969 8.478078 2 283 + 285 H -4.444519 -5.357513 8.149460 2 283 + 286 O -3.655884 2.941259 -3.295211 1 287 288 + 287 H -4.418712 2.528163 -3.712668 2 286 + 288 H -2.937568 3.025005 -3.971189 2 286 + 289 O -8.786626 -3.149090 -1.640379 1 290 291 + 290 H -8.441651 -4.011755 -1.901885 2 289 + 291 H -9.285717 -3.276173 -0.834535 2 289 + 292 O -7.358188 8.239942 -2.093781 1 293 294 + 293 H -7.811518 7.751233 -2.768278 2 292 + 294 H -6.892430 7.625331 -1.541437 2 292 + 295 O 3.770974 -0.453172 -1.931225 1 296 297 + 296 H 4.245757 -0.966218 -1.286114 2 295 + 297 H 3.797803 0.441972 -1.542180 2 295 + 298 O 2.205813 4.098894 8.958738 1 299 300 + 299 H 3.001973 3.555440 8.746430 2 298 + 300 H 2.103639 4.243668 9.940011 2 298 + 301 O -8.723398 -8.284874 -8.890692 1 302 303 + 302 H -9.298972 -7.537539 -9.239127 2 301 + 303 H -8.772683 -8.361037 -7.925940 2 301 + 304 O -8.908952 0.807167 -7.785764 1 305 306 + 305 H -9.061230 -0.061912 -7.422589 2 304 + 306 H -9.534219 1.030144 -8.475490 2 304 + 307 O 9.182207 -3.418263 -8.430667 1 308 309 + 308 H 9.046738 -2.558299 -8.879898 2 307 + 309 H 8.390804 -3.958734 -8.701949 2 307 + 310 O 1.003162 9.279867 -8.313986 1 311 312 + 311 H 1.167271 10.190392 -8.070619 2 310 + 312 H 1.849962 8.761188 -8.493178 2 310 + 313 O -1.842572 4.893383 8.198130 1 314 315 + 314 H -2.468210 5.316242 8.833179 2 313 + 315 H -1.155294 4.389410 8.716281 2 313 + 316 O -4.005055 -3.953707 0.402347 1 317 318 + 317 H -3.682148 -3.305443 1.058769 2 316 + 318 H -4.738199 -4.452434 0.841144 2 316 + 319 O 3.511815 -7.590537 -9.004707 1 320 321 + 320 H 3.415066 -7.281286 -8.094635 2 319 + 321 H 3.251550 -6.835442 -9.579171 2 319 + 322 O -7.614136 -7.773463 1.262079 1 323 324 + 323 H -7.489497 -6.927033 0.753779 2 322 + 324 H -8.528840 -8.050689 1.164710 2 322 + 325 O -5.419143 7.061880 -5.745275 1 326 327 + 326 H -4.504905 6.840455 -5.750772 2 325 + 327 H -5.895918 6.221393 -5.676189 2 325 + 328 O -9.017162 1.888781 0.937813 1 329 330 + 329 H -9.868157 2.115056 0.623903 2 328 + 330 H -8.466599 1.708818 0.191067 2 328 + 331 O -8.037596 -5.106016 4.750802 1 332 333 + 332 H -7.322228 -5.707104 5.043673 2 331 + 333 H -8.230169 -4.481051 5.475067 2 331 + 334 O -4.390546 1.691502 -7.756245 1 335 336 + 335 H -3.558844 1.264966 -7.996466 2 334 + 336 H -4.136121 2.629917 -7.760619 2 334 + 337 O -3.975194 -6.218233 -6.927330 1 338 339 + 338 H -3.085645 -6.066352 -7.325296 2 337 + 339 H -4.640815 -6.676349 -7.524295 2 337 + 340 O 8.240648 5.082183 -8.857912 1 341 342 + 341 H 7.453645 5.101728 -8.259448 2 340 + 342 H 8.368223 4.228825 -9.227974 2 340 + 343 O 1.598931 -1.829796 -0.316752 1 344 345 + 344 H 1.992252 -1.475465 -1.149815 2 343 + 345 H 1.726926 -2.749881 -0.397199 2 343 + 346 O 1.433819 -1.386702 -3.304673 1 347 348 + 347 H 1.323094 -0.486757 -3.067110 2 346 + 348 H 0.623143 -1.802016 -3.264828 2 346 + 349 O 3.735991 5.554990 6.219603 1 350 351 + 350 H 3.320916 6.265941 6.761937 2 349 + 351 H 4.195666 6.053207 5.526652 2 349 + 352 O -6.285976 -9.228132 -4.460410 1 353 354 + 353 H -5.683885 -10.005163 -4.740870 2 352 + 354 H -6.707036 -9.488426 -3.608438 2 352 + 355 O 4.036200 -3.378299 6.905724 1 356 357 + 356 H 3.457441 -2.618106 6.794504 2 355 + 357 H 4.929409 -2.991177 6.666963 2 355 + 358 O 0.606517 8.561279 -3.782406 1 359 360 + 359 H 0.498099 9.526035 -3.699299 2 358 + 360 H 1.288545 8.500162 -4.475972 2 358 + 361 O -5.666717 8.368298 -8.299623 1 362 363 + 362 H -4.926661 7.904359 -8.744783 2 361 + 363 H -5.742748 8.095703 -7.389592 2 361 + 364 O -3.344692 7.636718 3.475830 1 365 366 + 365 H -4.140634 7.105012 3.296472 2 364 + 366 H -3.350797 7.470949 4.433350 2 364 + 367 O -1.322186 6.638182 0.028906 1 368 369 + 368 H -1.895088 6.054034 0.554933 2 367 + 369 H -1.928852 7.271511 -0.442137 2 367 + 370 O 8.793551 6.925450 7.841717 1 371 372 + 371 H 9.639675 7.325848 7.850680 2 370 + 372 H 8.776882 6.398711 8.674036 2 370 + 373 O -6.322101 0.607808 1.174099 1 374 375 + 374 H -5.647986 1.150825 1.588348 2 373 + 375 H -5.852992 -0.060471 0.660730 2 373 + 376 O 5.685139 -3.546046 -4.128549 1 377 378 + 377 H 4.727966 -3.473549 -4.165755 2 376 + 378 H 6.024761 -2.749532 -4.610993 2 376 + 379 O 3.821999 6.538527 1.678030 1 380 381 + 380 H 3.549684 7.331168 1.175762 2 379 + 381 H 3.816423 6.788603 2.602522 2 379 + 382 O 3.892622 -7.034239 -6.415978 1 383 384 + 383 H 4.720509 -6.539827 -6.295004 2 382 + 384 H 3.262810 -6.550918 -5.890370 2 382 + 385 O 5.454437 3.881722 -2.767521 1 386 387 + 386 H 5.906266 3.240489 -3.272250 2 385 + 387 H 6.116652 4.657253 -2.669082 2 385 + 388 O -4.179373 -8.326009 4.395005 1 389 390 + 389 H -3.737878 -8.754475 5.134173 2 388 + 390 H -3.934584 -8.825320 3.534465 2 388 + 391 O 7.949488 -1.353498 9.244688 1 392 393 + 392 H 7.234465 -1.100736 9.869694 2 391 + 393 H 8.010855 -0.754076 8.476271 2 391 + 394 O 4.498603 -4.219267 3.963173 1 395 396 + 395 H 4.895226 -3.311215 4.147093 2 394 + 396 H 4.802371 -4.871698 4.671292 2 394 + 397 O -4.307250 7.384668 -2.879462 1 398 399 + 398 H -3.402854 7.237543 -3.252031 2 397 + 399 H -4.143231 7.834459 -2.019767 2 397 + 400 O 2.868752 -0.418389 1.909340 1 401 402 + 401 H 2.544472 -0.880398 1.179279 2 400 + 402 H 2.082841 -0.227627 2.457964 2 400 + 403 O 7.961389 1.611971 4.525253 1 404 405 + 404 H 7.498497 1.833174 3.728113 2 403 + 405 H 8.841880 2.050996 4.576281 2 403 + 406 O 2.692467 -4.517946 -0.884665 1 407 408 + 407 H 1.789435 -4.835617 -0.587396 2 406 + 408 H 3.330887 -5.126025 -0.474679 2 406 + 409 O 0.711797 1.680547 -4.780435 1 410 411 + 410 H 0.854596 1.567911 -3.850059 2 409 + 411 H -0.187286 1.868256 -4.936632 2 409 + 412 O 4.558200 -0.044434 -4.673875 1 413 414 + 413 H 5.376141 -0.551202 -4.913295 2 412 + 414 H 4.409600 -0.197728 -3.739555 2 412 + 415 O 7.109730 0.453475 -0.268844 1 416 417 + 416 H 6.996444 0.098599 -1.119484 2 415 + 417 H 6.343115 1.050849 -0.110689 2 415 + 418 O -2.549577 -0.200852 -4.492507 1 419 420 + 419 H -3.199039 -0.856439 -4.888752 2 418 + 420 H -2.605120 -0.151501 -3.534000 2 418 + 421 O -8.527353 4.524174 -2.347408 1 422 423 + 422 H -7.662213 4.342466 -2.104852 2 421 + 423 H -8.794374 3.696793 -2.795740 2 421 + 424 O -2.820431 -0.700478 4.413266 1 425 426 + 425 H -2.088343 -0.069797 4.530521 2 424 + 426 H -3.535913 -0.413547 5.069151 2 424 + 427 O 6.924598 -1.285634 -4.901833 1 428 429 + 428 H 7.496477 -0.831510 -4.206076 2 427 + 429 H 7.527035 -1.446676 -5.677236 2 427 + 430 O -5.353763 6.572088 6.734366 1 431 432 + 431 H -4.428432 6.663173 6.834862 2 430 + 432 H -5.603600 6.385787 5.822425 2 430 + 433 O 7.661597 2.386104 9.175259 1 434 435 + 434 H 7.321694 2.395921 10.055536 2 433 + 435 H 6.959141 2.102200 8.533079 2 433 + 436 O -3.496590 -3.765912 -4.994838 1 437 438 + 437 H -3.612181 -3.620689 -4.036115 2 436 + 438 H -4.323649 -3.527816 -5.463213 2 436 + 439 O -9.351953 8.343146 3.704719 1 440 441 + 440 H -8.465363 8.758592 3.736785 2 439 + 441 H -9.159223 7.399420 3.880808 2 439 + 442 O -0.957571 -5.174275 -2.190170 1 443 444 + 443 H -1.907345 -5.209294 -2.303164 2 442 + 444 H -0.758582 -4.314608 -2.636469 2 442 + 445 O 5.048831 -7.988284 2.587515 1 446 447 + 446 H 5.870168 -8.296198 3.043816 2 445 + 447 H 4.551970 -7.498875 3.229280 2 445 + 448 O 3.705658 8.368298 -8.304931 1 449 450 + 449 H 3.860607 9.297256 -8.425405 2 448 + 450 H 3.866516 8.146007 -7.371475 2 448 + 451 O -2.535134 7.116414 6.338590 1 452 453 + 452 H -1.918884 7.705593 6.804078 2 451 + 453 H -1.975225 6.330832 6.121365 2 451 + 454 O -3.440263 7.005018 9.111704 1 455 456 + 455 H -2.633953 7.421761 9.465848 2 454 + 456 H -3.654896 7.513753 8.256470 2 454 + 457 O 6.452501 -5.478051 -5.722874 1 458 459 + 458 H 7.297698 -5.914122 -5.586895 2 457 + 459 H 6.253267 -4.919338 -4.937095 2 457 + 460 O -6.528475 4.497861 -5.573636 1 461 462 + 461 H -6.257840 4.684056 -4.656222 2 460 + 462 H -7.247764 3.931701 -5.623068 2 460 + 463 O -7.310706 8.183648 7.852201 1 464 465 + 464 H -6.552879 7.735013 7.436342 2 463 + 465 H -6.877865 8.451022 8.686616 2 463 + 466 O -1.476441 -7.867001 7.421787 1 467 468 + 467 H -0.852398 -8.570669 7.084405 2 466 + 468 H -1.363740 -7.190554 6.737331 2 466 + 469 O 5.228019 -0.495870 -7.592953 1 470 471 + 470 H 4.737616 -0.538139 -6.742036 2 469 + 471 H 4.625354 -0.901329 -8.269022 2 469 + 472 O 7.566531 -1.006734 1.808213 1 473 474 + 473 H 7.657411 -1.866188 1.428564 2 472 + 474 H 7.358547 -0.388051 1.139943 2 472 + 475 O 1.850924 -5.717449 -5.035416 1 476 477 + 476 H 1.721040 -6.227449 -4.217213 2 475 + 477 H 2.199319 -4.856378 -4.692892 2 475 + 478 O -8.904325 6.791585 -3.842866 1 479 480 + 479 H -8.690637 5.952112 -3.490118 2 478 + 480 H -8.676001 6.844077 -4.770651 2 478 + 481 O -3.434304 4.397198 -7.863568 1 482 483 + 482 H -2.634777 3.892027 -7.779256 2 481 + 483 H -3.432847 5.161485 -7.310788 2 481 + 484 O -7.446738 6.124823 0.150068 1 485 486 + 485 H -7.404893 5.207959 0.481504 2 484 + 486 H -8.405563 6.215466 -0.024439 2 484 + 487 O 0.195330 -7.307128 -3.501714 1 488 489 + 488 H -0.240912 -6.769004 -4.243655 2 487 + 489 H -0.194915 -6.981989 -2.679860 2 487 + 490 O 7.068819 9.130323 7.260588 1 491 492 + 491 H 6.559855 8.400987 7.699406 2 490 + 492 H 7.972497 8.829223 7.213747 2 490 + 493 O -0.185218 -3.192290 -6.289346 1 494 495 + 494 H 0.776651 -3.073203 -6.391948 2 493 + 495 H -0.497426 -2.964088 -7.170893 2 493 + 496 O -2.073630 4.369672 5.251074 1 497 498 + 497 H -1.868638 3.811508 6.060261 2 496 + 498 H -1.253174 4.326708 4.781680 2 496 + 499 O -0.855003 3.069108 -7.935226 1 500 501 + 500 H 0.075758 3.132202 -7.617253 2 499 + 501 H -1.009845 2.207487 -8.320426 2 499 + 502 O -6.328833 0.064083 -8.467228 1 503 504 + 503 H -7.268416 0.384648 -8.383978 2 502 + 504 H -5.825246 0.919304 -8.320175 2 502 + 505 O -8.276352 -8.809851 -6.344910 1 506 507 + 506 H -7.541457 -8.792368 -5.688031 2 505 + 507 H -8.510208 -9.731116 -6.353248 2 505 + 508 O 0.463654 2.826776 7.018388 1 509 510 + 509 H 0.875324 3.588447 7.482107 2 508 + 510 H 0.770257 2.126646 7.583650 2 508 + 511 O 0.478371 -3.407198 6.910039 1 512 513 + 512 H 0.585298 -2.996750 7.756467 2 511 + 513 H 0.556531 -4.390636 7.183527 2 511 + 514 O -1.689559 7.002511 -3.303561 1 515 516 + 515 H -1.009152 7.635432 -3.553133 2 514 + 516 H -1.333699 6.195680 -2.919485 2 514 + 517 O 9.000097 -6.227871 8.137681 1 518 519 + 518 H 9.373858 -6.821152 7.497417 2 517 + 519 H 8.024020 -6.011019 8.033727 2 517 + 520 O 1.272378 1.954065 3.058033 1 521 522 + 521 H 1.260842 2.615112 2.341207 2 520 + 522 H 1.890312 2.223439 3.732934 2 520 + 523 O 4.139066 -3.527427 -9.022609 1 524 525 + 524 H 4.070028 -3.499117 -9.985525 2 523 + 525 H 4.960292 -3.942364 -8.778433 2 523 + 526 O 7.176276 2.178662 -4.075940 1 527 528 + 527 H 6.995275 1.684022 -4.873223 2 526 + 528 H 7.621313 2.984315 -4.393994 2 526 + 529 O -0.034836 -3.929919 2.148095 1 530 531 + 530 H 0.838003 -3.513346 2.259663 2 529 + 531 H -0.654999 -3.288581 2.426748 2 529 + 532 O -8.701616 2.795237 -5.700842 1 533 534 + 533 H -8.848959 2.145603 -6.420186 2 532 + 534 H -9.464654 3.362988 -5.610379 2 532 + 535 O 2.804444 8.909551 -5.635389 1 536 537 + 536 H 3.063615 9.805993 -5.770957 2 535 + 537 H 3.512196 8.486179 -5.165468 2 535 + 538 O 3.236002 8.357402 3.636639 1 539 540 + 539 H 3.450854 9.071799 3.073263 2 538 + 540 H 3.476445 8.586691 4.607935 2 538 + 541 O 5.628532 7.185941 8.510937 1 542 543 + 542 H 5.467837 6.318153 8.138885 2 541 + 543 H 4.964153 7.477925 9.150467 2 541 + 544 O -3.767261 1.260390 2.017681 1 545 546 + 545 H -3.707734 2.019520 2.565591 2 544 + 546 H -3.364602 1.609935 1.212351 2 544 + 547 O 8.228917 -3.441761 0.850139 1 548 549 + 548 H 9.022130 -3.709208 1.334881 2 547 + 549 H 7.553662 -3.976731 1.276651 2 547 + 550 O -3.004292 1.345869 7.236734 1 551 552 + 551 H -3.715311 0.724731 6.912689 2 550 + 552 H -3.525684 2.111901 7.538936 2 550 + 553 O 4.901423 -5.547141 -0.119795 1 554 555 + 554 H 5.327550 -5.560969 0.769770 2 553 + 555 H 5.447642 -4.930752 -0.617088 2 553 + 556 O -3.306210 8.469477 -0.495057 1 557 558 + 557 H -2.836855 9.122642 -1.080706 2 556 + 558 H -3.311215 8.916887 0.353875 2 556 + 559 O -6.572180 3.018421 -0.262079 1 560 561 + 560 H -6.711444 2.659956 0.606460 2 559 + 561 H -6.040782 2.473886 -0.843542 2 559 + 562 O -5.429147 -5.967833 5.177682 1 563 564 + 563 H -4.896648 -6.608203 4.692534 2 562 + 564 H -5.386594 -6.130690 6.117931 2 562 + 565 O 6.054430 7.035601 0.031519 1 566 567 + 566 H 5.939348 7.951184 -0.141094 2 565 + 567 H 5.390949 6.866654 0.702638 2 565 + 568 O -0.890229 -2.615376 -3.621726 1 569 570 + 569 H -1.695442 -2.097314 -3.537976 2 568 + 570 H -0.895128 -2.637531 -4.561712 2 568 + 571 O -5.446979 0.994907 -2.106714 1 572 573 + 572 H -4.494883 0.997912 -1.881595 2 571 + 573 H -5.759736 0.094199 -1.919247 2 571 + 574 O -7.517688 -4.078340 7.202707 1 575 576 + 575 H -8.242348 -4.324693 7.729813 2 574 + 576 H -6.924399 -4.817453 7.269430 2 574 + 577 O -1.134884 8.628488 2.081069 1 578 579 + 578 H -1.962897 8.634713 2.554947 2 577 + 579 H -1.119731 7.882422 1.516003 2 577 + 580 O -6.288317 8.011683 2.022129 1 581 582 + 581 H -6.404647 8.858198 1.546109 2 580 + 582 H -6.669138 7.315199 1.482614 2 580 + 583 O -6.766934 -4.026505 -8.306645 1 584 585 + 584 H -6.542552 -4.855702 -8.828363 2 583 + 585 H -7.743726 -3.954163 -8.170031 2 583 + 586 O 6.895244 7.052113 -3.031289 1 587 588 + 587 H 7.810039 7.265357 -3.330751 2 586 + 588 H 6.666757 7.541675 -2.202178 2 586 + 589 O 8.003260 4.735929 -5.168656 1 590 591 + 590 H 7.233375 4.730204 -5.685772 2 589 + 591 H 8.406708 5.629580 -5.300038 2 589 + 592 O -5.230160 -6.461196 -4.390836 1 593 594 + 593 H -5.701559 -7.313756 -4.377348 2 592 + 594 H -4.855545 -6.327970 -5.273444 2 592 + 595 O -3.803496 -9.221115 7.305476 1 596 597 + 596 H -2.934288 -8.877999 7.425047 2 595 + 597 H -4.416066 -8.566250 7.573191 2 595 + 598 O -5.990438 -1.574415 3.072521 1 599 600 + 599 H -5.805447 -1.119293 3.933731 2 598 + 600 H -6.651651 -0.947206 2.634773 2 598 + 601 O 1.155451 7.138377 -1.178317 1 602 603 + 602 H 0.330359 7.363227 -0.724568 2 601 + 603 H 1.055145 7.478676 -2.100793 2 601 + 604 O -5.886817 5.150957 -2.997276 1 605 606 + 605 H -5.191777 4.556623 -2.611465 2 604 + 606 H -5.401622 6.003350 -3.064194 2 604 + 607 O 2.539927 3.387568 4.976180 1 608 609 + 608 H 1.760904 3.182324 5.589217 2 607 + 609 H 2.841539 4.315465 5.278853 2 607 + 610 O 8.331859 -7.344673 -5.188191 1 611 612 + 611 H 8.424401 -7.586778 -4.198621 2 610 + 612 H 8.911675 -7.764424 -5.823267 2 610 + 613 O -5.774081 1.315144 -5.304553 1 614 615 + 614 H -5.222992 1.580336 -6.077077 2 613 + 615 H -6.219878 2.178441 -5.093360 2 613 + 616 O 6.340084 -4.926064 2.149626 1 617 618 + 617 H 5.639784 -4.766017 2.829591 2 616 + 618 H 6.883511 -5.598794 2.562820 2 616 + 619 O -2.722394 6.614441 -5.843805 1 620 621 + 620 H -2.332414 7.251953 -6.403722 2 619 + 621 H -2.221682 6.596615 -5.034993 2 619 + 622 O -1.813152 0.712824 -9.048176 1 623 624 + 623 H -1.763921 -0.271744 -8.916841 2 622 + 624 H -2.097796 0.860500 -9.970314 2 622 + 625 O 6.146244 -6.879929 8.376712 1 626 627 + 626 H 5.324465 -7.183905 8.841506 2 625 + 627 H 6.642264 -7.749945 8.201756 2 625 + 628 O 2.887544 8.612615 0.453821 1 629 630 + 629 H 2.452117 8.047637 -0.251289 2 628 + 630 H 2.348751 9.285636 0.895642 2 628 + 631 O -8.475558 -8.180718 6.501232 1 632 633 + 632 H -8.034310 -8.945692 6.891221 2 631 + 633 H -8.173606 -8.179435 5.569319 2 631 + 634 O 6.714205 -2.947903 6.551671 1 635 636 + 635 H 7.143284 -2.459194 7.270891 2 634 + 636 H 7.212365 -2.637046 5.791018 2 634 + 637 O 6.445003 -5.462306 5.577966 1 638 639 + 638 H 6.730099 -4.696457 6.073312 2 637 + 639 H 6.099428 -6.099736 6.222859 2 637 + 640 O -1.818761 -6.080111 -8.805420 1 641 642 + 641 H -1.644534 -6.777931 -9.477669 2 640 + 642 H -2.078582 -5.258591 -9.215838 2 640 + 643 O 6.037377 2.950576 2.863541 1 644 645 + 644 H 6.409766 3.757001 2.570754 2 643 + 645 H 5.577033 2.617474 2.090587 2 643 + 646 O -7.731645 3.337668 3.301121 1 647 648 + 647 H -8.345957 4.027222 3.589257 2 646 + 648 H -8.130328 2.845238 2.577949 2 646 diff --git a/examples/amoeba/water_dimer.xyz b/examples/amoeba/water_dimer.xyz new file mode 100644 index 0000000000..5f2a27cc0b --- /dev/null +++ b/examples/amoeba/water_dimer.xyz @@ -0,0 +1,7 @@ + 6 Schaefer Water Dimer 1 + 1 O -0.024616 -0.001154 -0.003748 1 2 3 + 2 H -0.244211 -0.000666 0.933978 2 1 + 3 H 0.932234 -0.000406 -0.008705 2 1 + 4 O -0.892721 0.000120 2.773674 1 5 6 + 5 H -1.462996 0.755120 2.933870 2 4 + 6 H -1.461809 -0.755549 2.934934 2 4 diff --git a/examples/amoeba/water_hexamer.xyz b/examples/amoeba/water_hexamer.xyz new file mode 100644 index 0000000000..995b27ad70 --- /dev/null +++ b/examples/amoeba/water_hexamer.xyz @@ -0,0 +1,19 @@ + 18 TINKER Water Hexamer + 1 O -1.502169 -0.191359 1.434927 1 2 3 + 2 H -0.601054 -0.596972 1.553718 2 1 + 3 H -2.006698 -0.422327 2.219847 2 1 + 4 O -1.744575 -0.382348 -1.309144 1 5 6 + 5 H -1.888941 -0.479653 -0.347624 2 4 + 6 H -2.516835 -0.766765 -1.733766 2 4 + 7 O -0.560409 2.017830 -0.121984 1 8 9 + 8 H -0.947720 1.533567 0.625228 2 7 + 9 H -0.989831 1.592736 -0.877419 2 7 + 10 O 0.964803 -1.165765 1.439987 1 11 12 + 11 H 0.979557 -1.522041 0.527833 2 10 + 12 H 1.542224 -0.393692 1.344373 2 10 + 13 O 0.974705 -1.401503 -1.335970 1 14 15 + 14 H 0.065161 -1.118951 -1.522886 2 13 + 15 H 1.470709 -0.570933 -1.277710 2 13 + 16 O 2.002280 1.057824 -0.124502 1 17 18 + 17 H 1.141637 1.532266 -0.140121 2 16 + 18 H 2.674716 1.735342 -0.237995 2 16 diff --git a/src/KSPACE/gridcomm.cpp b/src/KSPACE/gridcomm.cpp index e37555080d..830f1347e4 100644 --- a/src/KSPACE/gridcomm.cpp +++ b/src/KSPACE/gridcomm.cpp @@ -17,6 +17,7 @@ #include "comm.h" #include "error.h" #include "irregular.h" +#include "pair.h" #include "kspace.h" #include "memory.h" @@ -926,31 +927,41 @@ int GridComm::ghost_adjacent_tiled() forward comm of my owned cells to other's ghost cells ------------------------------------------------------------------------- */ -void GridComm::forward_comm_kspace(KSpace *kspace, int nper, int nbyte, int which, - void *buf1, void *buf2, MPI_Datatype datatype) +void GridComm::forward_comm(KSpace *kspace, int nper, int nbyte, int which, + void *buf1, void *buf2, MPI_Datatype datatype) { if (layout == REGULAR) - forward_comm_kspace_regular(kspace,nper,nbyte,which,buf1,buf2,datatype); + forward_comm_regular(kspace,nper,nbyte,which,buf1,buf2,datatype); else - forward_comm_kspace_tiled(kspace,nper,nbyte,which,buf1,buf2,datatype); + forward_comm_tiled(kspace,nper,nbyte,which,buf1,buf2,datatype); +} + +void GridComm::forward_comm(Pair *pair, int nper, int nbyte, int which, + void *buf1, void *buf2, MPI_Datatype datatype) +{ + if (layout == REGULAR) + forward_comm_regular(pair,nper,nbyte,which,buf1,buf2,datatype); + else + forward_comm_tiled(pair,nper,nbyte,which,buf1,buf2,datatype); } /* ---------------------------------------------------------------------- forward comm on regular grid of procs via list of swaps with 6 neighbor procs ------------------------------------------------------------------------- */ +template void GridComm:: -forward_comm_kspace_regular(KSpace *kspace, int nper, int /*nbyte*/, int which, - void *buf1, void *buf2, MPI_Datatype datatype) +forward_comm_regular(T *caller, int nper, int /*nbyte*/, int which, + void *buf1, void *buf2, MPI_Datatype datatype) { int m; MPI_Request request; for (m = 0; m < nswap; m++) { if (swap[m].sendproc == me) - kspace->pack_forward_grid(which,buf2,swap[m].npack,swap[m].packlist); + caller->pack_forward_grid(which,buf2,swap[m].npack,swap[m].packlist); else - kspace->pack_forward_grid(which,buf1,swap[m].npack,swap[m].packlist); + caller->pack_forward_grid(which,buf1,swap[m].npack,swap[m].packlist); if (swap[m].sendproc != me) { if (swap[m].nunpack) MPI_Irecv(buf2,nper*swap[m].nunpack,datatype, @@ -960,7 +971,7 @@ forward_comm_kspace_regular(KSpace *kspace, int nper, int /*nbyte*/, int which, if (swap[m].nunpack) MPI_Wait(&request,MPI_STATUS_IGNORE); } - kspace->unpack_forward_grid(which,buf2,swap[m].nunpack,swap[m].unpacklist); + caller->unpack_forward_grid(which,buf2,swap[m].nunpack,swap[m].unpacklist); } } @@ -968,9 +979,10 @@ forward_comm_kspace_regular(KSpace *kspace, int nper, int /*nbyte*/, int which, forward comm on tiled grid decomp via Send/Recv lists of each neighbor proc ------------------------------------------------------------------------- */ +template void GridComm:: -forward_comm_kspace_tiled(KSpace *kspace, int nper, int nbyte, int which, - void *buf1, void *vbuf2, MPI_Datatype datatype) +forward_comm_tiled(T *caller, int nper, int nbyte, int which, + void *buf1, void *vbuf2, MPI_Datatype datatype) { int i,m,offset; @@ -987,15 +999,15 @@ forward_comm_kspace_tiled(KSpace *kspace, int nper, int nbyte, int which, // perform all sends to other procs for (m = 0; m < nsend; m++) { - kspace->pack_forward_grid(which,buf1,send[m].npack,send[m].packlist); + caller->pack_forward_grid(which,buf1,send[m].npack,send[m].packlist); MPI_Send(buf1,nper*send[m].npack,datatype,send[m].proc,0,gridcomm); } // perform all copies to self for (m = 0; m < ncopy; m++) { - kspace->pack_forward_grid(which,buf1,copy[m].npack,copy[m].packlist); - kspace->unpack_forward_grid(which,buf1,copy[m].nunpack,copy[m].unpacklist); + caller->pack_forward_grid(which,buf1,copy[m].npack,copy[m].packlist); + caller->unpack_forward_grid(which,buf1,copy[m].nunpack,copy[m].unpacklist); } // unpack all received data @@ -1003,7 +1015,7 @@ forward_comm_kspace_tiled(KSpace *kspace, int nper, int nbyte, int which, for (i = 0; i < nrecv; i++) { MPI_Waitany(nrecv,requests,&m,MPI_STATUS_IGNORE); offset = nper * recv[m].offset * nbyte; - kspace->unpack_forward_grid(which,(void *) &buf2[offset], + caller->unpack_forward_grid(which,(void *) &buf2[offset], recv[m].nunpack,recv[m].unpacklist); } } @@ -1012,31 +1024,41 @@ forward_comm_kspace_tiled(KSpace *kspace, int nper, int nbyte, int which, reverse comm of my ghost cells to sum to owner cells ------------------------------------------------------------------------- */ -void GridComm::reverse_comm_kspace(KSpace *kspace, int nper, int nbyte, int which, - void *buf1, void *buf2, MPI_Datatype datatype) +void GridComm::reverse_comm(KSpace *kspace, int nper, int nbyte, int which, + void *buf1, void *buf2, MPI_Datatype datatype) { if (layout == REGULAR) - reverse_comm_kspace_regular(kspace,nper,nbyte,which,buf1,buf2,datatype); + reverse_comm_regular(kspace,nper,nbyte,which,buf1,buf2,datatype); else - reverse_comm_kspace_tiled(kspace,nper,nbyte,which,buf1,buf2,datatype); + reverse_comm_tiled(kspace,nper,nbyte,which,buf1,buf2,datatype); +} + +void GridComm::reverse_comm(Pair *pair, int nper, int nbyte, int which, + void *buf1, void *buf2, MPI_Datatype datatype) +{ + if (layout == REGULAR) + reverse_comm_regular(pair,nper,nbyte,which,buf1,buf2,datatype); + else + reverse_comm_tiled(pair,nper,nbyte,which,buf1,buf2,datatype); } /* ---------------------------------------------------------------------- reverse comm on regular grid of procs via list of swaps with 6 neighbor procs ------------------------------------------------------------------------- */ +template void GridComm:: -reverse_comm_kspace_regular(KSpace *kspace, int nper, int /*nbyte*/, int which, - void *buf1, void *buf2, MPI_Datatype datatype) +reverse_comm_regular(T *caller, int nper, int /*nbyte*/, int which, + void *buf1, void *buf2, MPI_Datatype datatype) { int m; MPI_Request request; for (m = nswap-1; m >= 0; m--) { if (swap[m].recvproc == me) - kspace->pack_reverse_grid(which,buf2,swap[m].nunpack,swap[m].unpacklist); + caller->pack_reverse_grid(which,buf2,swap[m].nunpack,swap[m].unpacklist); else - kspace->pack_reverse_grid(which,buf1,swap[m].nunpack,swap[m].unpacklist); + caller->pack_reverse_grid(which,buf1,swap[m].nunpack,swap[m].unpacklist); if (swap[m].recvproc != me) { if (swap[m].npack) MPI_Irecv(buf2,nper*swap[m].npack,datatype, @@ -1046,7 +1068,7 @@ reverse_comm_kspace_regular(KSpace *kspace, int nper, int /*nbyte*/, int which, if (swap[m].npack) MPI_Wait(&request,MPI_STATUS_IGNORE); } - kspace->unpack_reverse_grid(which,buf2,swap[m].npack,swap[m].packlist); + caller->unpack_reverse_grid(which,buf2,swap[m].npack,swap[m].packlist); } } @@ -1054,9 +1076,10 @@ reverse_comm_kspace_regular(KSpace *kspace, int nper, int /*nbyte*/, int which, reverse comm on tiled grid decomp via Send/Recv lists of each neighbor proc ------------------------------------------------------------------------- */ +template void GridComm:: -reverse_comm_kspace_tiled(KSpace *kspace, int nper, int nbyte, int which, - void *buf1, void *vbuf2, MPI_Datatype datatype) +reverse_comm_tiled(T *caller, int nper, int nbyte, int which, + void *buf1, void *vbuf2, MPI_Datatype datatype) { int i,m,offset; @@ -1073,15 +1096,15 @@ reverse_comm_kspace_tiled(KSpace *kspace, int nper, int nbyte, int which, // perform all sends to other procs for (m = 0; m < nrecv; m++) { - kspace->pack_reverse_grid(which,buf1,recv[m].nunpack,recv[m].unpacklist); + caller->pack_reverse_grid(which,buf1,recv[m].nunpack,recv[m].unpacklist); MPI_Send(buf1,nper*recv[m].nunpack,datatype,recv[m].proc,0,gridcomm); } // perform all copies to self for (m = 0; m < ncopy; m++) { - kspace->pack_reverse_grid(which,buf1,copy[m].nunpack,copy[m].unpacklist); - kspace->unpack_reverse_grid(which,buf1,copy[m].npack,copy[m].packlist); + caller->pack_reverse_grid(which,buf1,copy[m].nunpack,copy[m].unpacklist); + caller->unpack_reverse_grid(which,buf1,copy[m].npack,copy[m].packlist); } // unpack all received data @@ -1089,7 +1112,7 @@ reverse_comm_kspace_tiled(KSpace *kspace, int nper, int nbyte, int which, for (i = 0; i < nsend; i++) { MPI_Waitany(nsend,requests,&m,MPI_STATUS_IGNORE); offset = nper * send[m].offset * nbyte; - kspace->unpack_reverse_grid(which,(void *) &buf2[offset], + caller->unpack_reverse_grid(which,(void *) &buf2[offset], send[m].npack,send[m].packlist); } } diff --git a/src/KSPACE/gridcomm.h b/src/KSPACE/gridcomm.h index 03379bde99..de674efd9e 100644 --- a/src/KSPACE/gridcomm.h +++ b/src/KSPACE/gridcomm.h @@ -27,8 +27,11 @@ class GridComm : protected Pointers { virtual ~GridComm(); void setup(int &, int &); int ghost_adjacent(); - void forward_comm_kspace(class KSpace *, int, int, int, void *, void *, MPI_Datatype); - void reverse_comm_kspace(class KSpace *, int, int, int, void *, void *, MPI_Datatype); + + void forward_comm(class KSpace *, int, int, int, void *, void *, MPI_Datatype); + void forward_comm(class Pair *, int, int, int, void *, void *, MPI_Datatype); + void reverse_comm(class KSpace *, int, int, int, void *, void *, MPI_Datatype); + void reverse_comm(class Pair *, int, int, int, void *, void *, MPI_Datatype); protected: int me, nprocs; @@ -181,10 +184,14 @@ class GridComm : protected Pointers { int ghost_adjacent_regular(); int ghost_adjacent_tiled(); - void forward_comm_kspace_regular(class KSpace *, int, int, int, void *, void *, MPI_Datatype); - void forward_comm_kspace_tiled(class KSpace *, int, int, int, void *, void *, MPI_Datatype); - void reverse_comm_kspace_regular(class KSpace *, int, int, int, void *, void *, MPI_Datatype); - void reverse_comm_kspace_tiled(class KSpace *, int, int, int, void *, void *, MPI_Datatype); + template + void forward_comm_regular(T *, int, int, int, void *, void *, MPI_Datatype); + template + void forward_comm_tiled(T *, int, int, int, void *, void *, MPI_Datatype); + template + void reverse_comm_regular(T *, int, int, int, void *, void *, MPI_Datatype); + template + void reverse_comm_tiled(T *, int, int, int, void *, void *, MPI_Datatype); virtual void grow_swap(); void grow_overlap(); diff --git a/src/KSPACE/msm.cpp b/src/KSPACE/msm.cpp index 368121c815..7b306c7430 100644 --- a/src/KSPACE/msm.cpp +++ b/src/KSPACE/msm.cpp @@ -465,8 +465,8 @@ void MSM::compute(int eflag, int vflag) // to fully sum contribution in their 3d grid current_level = 0; - gcall->reverse_comm_kspace(this,1,sizeof(double),REVERSE_RHO, - gcall_buf1,gcall_buf2,MPI_DOUBLE); + gcall->reverse_comm(this,1,sizeof(double),REVERSE_RHO, + gcall_buf1,gcall_buf2,MPI_DOUBLE); // forward communicate charge density values to fill ghost grid points // compute direct sum interaction and then restrict to coarser grid @@ -474,8 +474,8 @@ void MSM::compute(int eflag, int vflag) for (int n=0; n<=levels-2; n++) { if (!active_flag[n]) continue; current_level = n; - gc[n]->forward_comm_kspace(this,1,sizeof(double),FORWARD_RHO, - gc_buf1[n],gc_buf2[n],MPI_DOUBLE); + gc[n]->forward_comm(this,1,sizeof(double),FORWARD_RHO, + gc_buf1[n],gc_buf2[n],MPI_DOUBLE); direct(n); restriction(n); } @@ -487,16 +487,16 @@ void MSM::compute(int eflag, int vflag) if (domain->nonperiodic) { current_level = levels-1; gc[levels-1]-> - forward_comm_kspace(this,1,sizeof(double),FORWARD_RHO, - gc_buf1[levels-1],gc_buf2[levels-1],MPI_DOUBLE); + forward_comm(this,1,sizeof(double),FORWARD_RHO, + gc_buf1[levels-1],gc_buf2[levels-1],MPI_DOUBLE); direct_top(levels-1); gc[levels-1]-> - reverse_comm_kspace(this,1,sizeof(double),REVERSE_AD, - gc_buf1[levels-1],gc_buf2[levels-1],MPI_DOUBLE); + reverse_comm(this,1,sizeof(double),REVERSE_AD, + gc_buf1[levels-1],gc_buf2[levels-1],MPI_DOUBLE); if (vflag_atom) gc[levels-1]-> - reverse_comm_kspace(this,6,sizeof(double),REVERSE_AD_PERATOM, - gc_buf1[levels-1],gc_buf2[levels-1],MPI_DOUBLE); + reverse_comm(this,6,sizeof(double),REVERSE_AD_PERATOM, + gc_buf1[levels-1],gc_buf2[levels-1],MPI_DOUBLE); } else { // Here using MPI_Allreduce is cheaper than using commgrid @@ -506,8 +506,8 @@ void MSM::compute(int eflag, int vflag) current_level = levels-1; if (vflag_atom) gc[levels-1]-> - reverse_comm_kspace(this,6,sizeof(double),REVERSE_AD_PERATOM, - gc_buf1[levels-1],gc_buf2[levels-1],MPI_DOUBLE); + reverse_comm(this,6,sizeof(double),REVERSE_AD_PERATOM, + gc_buf1[levels-1],gc_buf2[levels-1],MPI_DOUBLE); } } @@ -519,28 +519,28 @@ void MSM::compute(int eflag, int vflag) prolongation(n); current_level = n; - gc[n]->reverse_comm_kspace(this,1,sizeof(double),REVERSE_AD, - gc_buf1[n],gc_buf2[n],MPI_DOUBLE); + gc[n]->reverse_comm(this,1,sizeof(double),REVERSE_AD, + gc_buf1[n],gc_buf2[n],MPI_DOUBLE); // extra per-atom virial communication if (vflag_atom) - gc[n]->reverse_comm_kspace(this,6,sizeof(double),REVERSE_AD_PERATOM, - gc_buf1[n],gc_buf2[n],MPI_DOUBLE); + gc[n]->reverse_comm(this,6,sizeof(double),REVERSE_AD_PERATOM, + gc_buf1[n],gc_buf2[n],MPI_DOUBLE); } // all procs communicate E-field values // to fill ghost cells surrounding their 3d bricks current_level = 0; - gcall->forward_comm_kspace(this,1,sizeof(double),FORWARD_AD, - gcall_buf1,gcall_buf2,MPI_DOUBLE); + gcall->forward_comm(this,1,sizeof(double),FORWARD_AD, + gcall_buf1,gcall_buf2,MPI_DOUBLE); // extra per-atom energy/virial communication if (vflag_atom) - gcall->forward_comm_kspace(this,6,sizeof(double),FORWARD_AD_PERATOM, - gcall_buf1,gcall_buf2,MPI_DOUBLE); + gcall->forward_comm(this,6,sizeof(double),FORWARD_AD_PERATOM, + gcall_buf1,gcall_buf2,MPI_DOUBLE); // calculate the force on my particles (interpolation) diff --git a/src/KSPACE/msm_cg.cpp b/src/KSPACE/msm_cg.cpp index 81a1418fc7..8d53e70374 100644 --- a/src/KSPACE/msm_cg.cpp +++ b/src/KSPACE/msm_cg.cpp @@ -160,8 +160,8 @@ void MSMCG::compute(int eflag, int vflag) // to fully sum contribution in their 3d grid current_level = 0; - gcall->reverse_comm_kspace(this,1,sizeof(double),REVERSE_RHO, - gcall_buf1,gcall_buf2,MPI_DOUBLE); + gcall->reverse_comm(this,1,sizeof(double),REVERSE_RHO, + gcall_buf1,gcall_buf2,MPI_DOUBLE); // forward communicate charge density values to fill ghost grid points // compute direct sum interaction and then restrict to coarser grid @@ -169,8 +169,9 @@ void MSMCG::compute(int eflag, int vflag) for (n=0; n<=levels-2; n++) { if (!active_flag[n]) continue; current_level = n; - gc[n]->forward_comm_kspace(this,1,sizeof(double),FORWARD_RHO, - gc_buf1[n],gc_buf2[n],MPI_DOUBLE); + gc[n]->forward_comm(this,1,sizeof(double),FORWARD_RHO, + gc_buf1[n],gc_buf2[n],MPI_DOUBLE); + direct(n); restriction(n); } @@ -182,16 +183,16 @@ void MSMCG::compute(int eflag, int vflag) if (domain->nonperiodic) { current_level = levels-1; gc[levels-1]-> - forward_comm_kspace(this,1,sizeof(double),FORWARD_RHO, - gc_buf1[levels-1],gc_buf2[levels-1],MPI_DOUBLE); + forward_comm(this,1,sizeof(double),FORWARD_RHO, + gc_buf1[levels-1],gc_buf2[levels-1],MPI_DOUBLE); direct_top(levels-1); gc[levels-1]-> - reverse_comm_kspace(this,1,sizeof(double),REVERSE_AD, - gc_buf1[levels-1],gc_buf2[levels-1],MPI_DOUBLE); + reverse_comm(this,1,sizeof(double),REVERSE_AD, + gc_buf1[levels-1],gc_buf2[levels-1],MPI_DOUBLE); if (vflag_atom) - gc[levels-1]-> - reverse_comm_kspace(this,6,sizeof(double),REVERSE_AD_PERATOM, - gc_buf1[levels-1],gc_buf2[levels-1],MPI_DOUBLE); + gc[levels-1]-> + reverse_comm(this,6,sizeof(double),REVERSE_AD_PERATOM, + gc_buf1[levels-1],gc_buf2[levels-1],MPI_DOUBLE); } else { // Here using MPI_Allreduce is cheaper than using commgrid @@ -200,9 +201,9 @@ void MSMCG::compute(int eflag, int vflag) grid_swap_reverse(levels-1,egrid[levels-1]); current_level = levels-1; if (vflag_atom) - gc[levels-1]-> - reverse_comm_kspace(this,6,sizeof(double),REVERSE_AD_PERATOM, - gc_buf1[levels-1],gc_buf2[levels-1],MPI_DOUBLE); + gc[levels-1]-> + reverse_comm(this,6,sizeof(double),REVERSE_AD_PERATOM, + gc_buf1[levels-1],gc_buf2[levels-1],MPI_DOUBLE); } } @@ -214,28 +215,28 @@ void MSMCG::compute(int eflag, int vflag) prolongation(n); current_level = n; - gc[n]->reverse_comm_kspace(this,1,sizeof(double),REVERSE_AD, - gc_buf1[n],gc_buf2[n],MPI_DOUBLE); + gc[n]->reverse_comm(this,1,sizeof(double),REVERSE_AD, + gc_buf1[n],gc_buf2[n],MPI_DOUBLE); // extra per-atom virial communication if (vflag_atom) - gc[n]->reverse_comm_kspace(this,6,sizeof(double),REVERSE_AD_PERATOM, - gc_buf1[n],gc_buf2[n],MPI_DOUBLE); + gc[n]->reverse_comm(this,6,sizeof(double),REVERSE_AD_PERATOM, + gc_buf1[n],gc_buf2[n],MPI_DOUBLE); } // all procs communicate E-field values // to fill ghost cells surrounding their 3d bricks current_level = 0; - gcall->forward_comm_kspace(this,1,sizeof(double),FORWARD_AD, - gcall_buf1,gcall_buf2,MPI_DOUBLE); + gcall->forward_comm(this,1,sizeof(double),FORWARD_AD, + gcall_buf1,gcall_buf2,MPI_DOUBLE); // extra per-atom energy/virial communication if (vflag_atom) - gcall->forward_comm_kspace(this,6,sizeof(double),FORWARD_AD_PERATOM, - gcall_buf1,gcall_buf2,MPI_DOUBLE); + gcall->forward_comm(this,6,sizeof(double),FORWARD_AD_PERATOM, + gcall_buf1,gcall_buf2,MPI_DOUBLE); // calculate the force on my particles (interpolation) diff --git a/src/KSPACE/pppm.cpp b/src/KSPACE/pppm.cpp index 1c409d5279..82035cfc35 100644 --- a/src/KSPACE/pppm.cpp +++ b/src/KSPACE/pppm.cpp @@ -638,8 +638,8 @@ void PPPM::compute(int eflag, int vflag) // to fully sum contribution in their 3d bricks // remap from 3d decomposition to FFT decomposition - gc->reverse_comm_kspace(this,1,sizeof(FFT_SCALAR),REVERSE_RHO, - gc_buf1,gc_buf2,MPI_FFT_SCALAR); + gc->reverse_comm(this,1,sizeof(FFT_SCALAR),REVERSE_RHO, + gc_buf1,gc_buf2,MPI_FFT_SCALAR); brick2fft(); // compute potential gradient on my FFT grid and @@ -653,21 +653,21 @@ void PPPM::compute(int eflag, int vflag) // to fill ghost cells surrounding their 3d bricks if (differentiation_flag == 1) - gc->forward_comm_kspace(this,1,sizeof(FFT_SCALAR),FORWARD_AD, - gc_buf1,gc_buf2,MPI_FFT_SCALAR); + gc->forward_comm(this,1,sizeof(FFT_SCALAR),FORWARD_AD, + gc_buf1,gc_buf2,MPI_FFT_SCALAR); else - gc->forward_comm_kspace(this,3,sizeof(FFT_SCALAR),FORWARD_IK, - gc_buf1,gc_buf2,MPI_FFT_SCALAR); + gc->forward_comm(this,3,sizeof(FFT_SCALAR),FORWARD_IK, + gc_buf1,gc_buf2,MPI_FFT_SCALAR); // extra per-atom energy/virial communication if (evflag_atom) { if (differentiation_flag == 1 && vflag_atom) - gc->forward_comm_kspace(this,6,sizeof(FFT_SCALAR),FORWARD_AD_PERATOM, - gc_buf1,gc_buf2,MPI_FFT_SCALAR); + gc->forward_comm(this,6,sizeof(FFT_SCALAR),FORWARD_AD_PERATOM, + gc_buf1,gc_buf2,MPI_FFT_SCALAR); else if (differentiation_flag == 0) - gc->forward_comm_kspace(this,7,sizeof(FFT_SCALAR),FORWARD_IK_PERATOM, - gc_buf1,gc_buf2,MPI_FFT_SCALAR); + gc->forward_comm(this,7,sizeof(FFT_SCALAR),FORWARD_IK_PERATOM, + gc_buf1,gc_buf2,MPI_FFT_SCALAR); } // calculate the force on my particles @@ -3119,8 +3119,8 @@ void PPPM::compute_group_group(int groupbit_A, int groupbit_B, int AA_flag) density_brick = density_A_brick; density_fft = density_A_fft; - gc->reverse_comm_kspace(this,1,sizeof(FFT_SCALAR),REVERSE_RHO, - gc_buf1,gc_buf2,MPI_FFT_SCALAR); + gc->reverse_comm(this,1,sizeof(FFT_SCALAR),REVERSE_RHO, + gc_buf1,gc_buf2,MPI_FFT_SCALAR); brick2fft(); // group B @@ -3128,8 +3128,8 @@ void PPPM::compute_group_group(int groupbit_A, int groupbit_B, int AA_flag) density_brick = density_B_brick; density_fft = density_B_fft; - gc->reverse_comm_kspace(this,1,sizeof(FFT_SCALAR),REVERSE_RHO, - gc_buf1,gc_buf2,MPI_FFT_SCALAR); + gc->reverse_comm(this,1,sizeof(FFT_SCALAR),REVERSE_RHO, + gc_buf1,gc_buf2,MPI_FFT_SCALAR); brick2fft(); // switch back pointers diff --git a/src/KSPACE/pppm_cg.cpp b/src/KSPACE/pppm_cg.cpp index 825547e573..8a644f01bf 100644 --- a/src/KSPACE/pppm_cg.cpp +++ b/src/KSPACE/pppm_cg.cpp @@ -177,8 +177,8 @@ void PPPMCG::compute(int eflag, int vflag) // to fully sum contribution in their 3d bricks // remap from 3d decomposition to FFT decomposition - gc->reverse_comm_kspace(this,1,sizeof(FFT_SCALAR),REVERSE_RHO, - gc_buf1,gc_buf2,MPI_FFT_SCALAR); + gc->reverse_comm(this,1,sizeof(FFT_SCALAR),REVERSE_RHO, + gc_buf1,gc_buf2,MPI_FFT_SCALAR); brick2fft(); // compute potential gradient on my FFT grid and @@ -192,21 +192,21 @@ void PPPMCG::compute(int eflag, int vflag) // to fill ghost cells surrounding their 3d bricks if (differentiation_flag == 1) - gc->forward_comm_kspace(this,1,sizeof(FFT_SCALAR),FORWARD_AD, - gc_buf1,gc_buf2,MPI_FFT_SCALAR); + gc->forward_comm(this,1,sizeof(FFT_SCALAR),FORWARD_AD, + gc_buf1,gc_buf2,MPI_FFT_SCALAR); else - gc->forward_comm_kspace(this,3,sizeof(FFT_SCALAR),FORWARD_IK, - gc_buf1,gc_buf2,MPI_FFT_SCALAR); + gc->forward_comm(this,3,sizeof(FFT_SCALAR),FORWARD_IK, + gc_buf1,gc_buf2,MPI_FFT_SCALAR); // extra per-atom energy/virial communication if (evflag_atom) { if (differentiation_flag == 1 && vflag_atom) - gc->forward_comm_kspace(this,6,sizeof(FFT_SCALAR),FORWARD_AD_PERATOM, - gc_buf1,gc_buf2,MPI_FFT_SCALAR); + gc->forward_comm(this,6,sizeof(FFT_SCALAR),FORWARD_AD_PERATOM, + gc_buf1,gc_buf2,MPI_FFT_SCALAR); else if (differentiation_flag == 0) - gc->forward_comm_kspace(this,7,sizeof(FFT_SCALAR),FORWARD_IK_PERATOM, - gc_buf1,gc_buf2,MPI_FFT_SCALAR); + gc->forward_comm(this,7,sizeof(FFT_SCALAR),FORWARD_IK_PERATOM, + gc_buf1,gc_buf2,MPI_FFT_SCALAR); } // calculate the force on my particles diff --git a/src/KSPACE/pppm_dipole.cpp b/src/KSPACE/pppm_dipole.cpp index a730d8214b..268a019b25 100644 --- a/src/KSPACE/pppm_dipole.cpp +++ b/src/KSPACE/pppm_dipole.cpp @@ -443,8 +443,8 @@ void PPPMDipole::compute(int eflag, int vflag) // to fully sum contribution in their 3d bricks // remap from 3d decomposition to FFT decomposition - gc_dipole->reverse_comm_kspace(this,3,sizeof(FFT_SCALAR),REVERSE_MU, - gc_buf1,gc_buf2,MPI_FFT_SCALAR); + gc_dipole->reverse_comm(this,3,sizeof(FFT_SCALAR),REVERSE_MU, + gc_buf1,gc_buf2,MPI_FFT_SCALAR); brick2fft_dipole(); // compute potential gradient on my FFT grid and @@ -457,14 +457,14 @@ void PPPMDipole::compute(int eflag, int vflag) // all procs communicate E-field values // to fill ghost cells surrounding their 3d bricks - gc_dipole->forward_comm_kspace(this,9,sizeof(FFT_SCALAR),FORWARD_MU, - gc_buf1,gc_buf2,MPI_FFT_SCALAR); + gc_dipole->forward_comm(this,9,sizeof(FFT_SCALAR),FORWARD_MU, + gc_buf1,gc_buf2,MPI_FFT_SCALAR); // extra per-atom energy/virial communication if (evflag_atom) - gc_dipole->forward_comm_kspace(this,18,sizeof(FFT_SCALAR),FORWARD_MU_PERATOM, - gc_buf1,gc_buf2,MPI_FFT_SCALAR); + gc_dipole->forward_comm(this,18,sizeof(FFT_SCALAR),FORWARD_MU_PERATOM, + gc_buf1,gc_buf2,MPI_FFT_SCALAR); // calculate the force on my particles diff --git a/src/KSPACE/pppm_dipole_spin.cpp b/src/KSPACE/pppm_dipole_spin.cpp index bff33bc3eb..7f8e8f1dbd 100644 --- a/src/KSPACE/pppm_dipole_spin.cpp +++ b/src/KSPACE/pppm_dipole_spin.cpp @@ -299,8 +299,8 @@ void PPPMDipoleSpin::compute(int eflag, int vflag) // to fully sum contribution in their 3d bricks // remap from 3d decomposition to FFT decomposition - gc_dipole->reverse_comm_kspace(this,3,sizeof(FFT_SCALAR),REVERSE_MU, - gc_buf1,gc_buf2,MPI_FFT_SCALAR); + gc_dipole->reverse_comm(this,3,sizeof(FFT_SCALAR),REVERSE_MU, + gc_buf1,gc_buf2,MPI_FFT_SCALAR); brick2fft_dipole(); // compute potential gradient on my FFT grid and @@ -313,14 +313,14 @@ void PPPMDipoleSpin::compute(int eflag, int vflag) // all procs communicate E-field values // to fill ghost cells surrounding their 3d bricks - gc_dipole->forward_comm_kspace(this,9,sizeof(FFT_SCALAR),FORWARD_MU, - gc_buf1,gc_buf2,MPI_FFT_SCALAR); + gc_dipole->forward_comm(this,9,sizeof(FFT_SCALAR),FORWARD_MU, + gc_buf1,gc_buf2,MPI_FFT_SCALAR); // extra per-atom energy/virial communication if (evflag_atom) - gc->forward_comm_kspace(this,18,sizeof(FFT_SCALAR),FORWARD_MU_PERATOM, - gc_buf1,gc_buf2,MPI_FFT_SCALAR); + gc->forward_comm(this,18,sizeof(FFT_SCALAR),FORWARD_MU_PERATOM, + gc_buf1,gc_buf2,MPI_FFT_SCALAR); // calculate the force on my particles diff --git a/src/KSPACE/pppm_disp.cpp b/src/KSPACE/pppm_disp.cpp index 7444b5f1e2..9c4e0565cc 100644 --- a/src/KSPACE/pppm_disp.cpp +++ b/src/KSPACE/pppm_disp.cpp @@ -930,8 +930,8 @@ void PPPMDisp::compute(int eflag, int vflag) make_rho_c(); - gc->reverse_comm_kspace(this,1,sizeof(FFT_SCALAR),REVERSE_RHO, - gc_buf1,gc_buf2,MPI_FFT_SCALAR); + gc->reverse_comm(this,1,sizeof(FFT_SCALAR),REVERSE_RHO, + gc_buf1,gc_buf2,MPI_FFT_SCALAR); brick2fft(nxlo_in,nylo_in,nzlo_in,nxhi_in,nyhi_in,nzhi_in, density_brick,density_fft,work1,remap); @@ -945,14 +945,14 @@ void PPPMDisp::compute(int eflag, int vflag) virial_1,vg,vg2, u_brick,v0_brick,v1_brick,v2_brick,v3_brick,v4_brick,v5_brick); - gc->forward_comm_kspace(this,1,sizeof(FFT_SCALAR),FORWARD_AD, - gc_buf1,gc_buf2,MPI_FFT_SCALAR); + gc->forward_comm(this,1,sizeof(FFT_SCALAR),FORWARD_AD, + gc_buf1,gc_buf2,MPI_FFT_SCALAR); fieldforce_c_ad(); if (vflag_atom) - gc->forward_comm_kspace(this,6,sizeof(FFT_SCALAR),FORWARD_AD_PERATOM, - gc_buf1,gc_buf2,MPI_FFT_SCALAR); + gc->forward_comm(this,6,sizeof(FFT_SCALAR),FORWARD_AD_PERATOM, + gc_buf1,gc_buf2,MPI_FFT_SCALAR); } else { poisson_ik(work1,work2,density_fft,fft1,fft2, @@ -964,14 +964,14 @@ void PPPMDisp::compute(int eflag, int vflag) vdx_brick,vdy_brick,vdz_brick,virial_1,vg,vg2, u_brick,v0_brick,v1_brick,v2_brick,v3_brick,v4_brick,v5_brick); - gc->forward_comm_kspace(this,3,sizeof(FFT_SCALAR),FORWARD_IK, - gc_buf1,gc_buf2,MPI_FFT_SCALAR); + gc->forward_comm(this,3,sizeof(FFT_SCALAR),FORWARD_IK, + gc_buf1,gc_buf2,MPI_FFT_SCALAR); fieldforce_c_ik(); if (evflag_atom) - gc->forward_comm_kspace(this,7,sizeof(FFT_SCALAR),FORWARD_IK_PERATOM, - gc_buf1,gc_buf2,MPI_FFT_SCALAR); + gc->forward_comm(this,7,sizeof(FFT_SCALAR),FORWARD_IK_PERATOM, + gc_buf1,gc_buf2,MPI_FFT_SCALAR); } if (evflag_atom) fieldforce_c_peratom(); @@ -988,8 +988,8 @@ void PPPMDisp::compute(int eflag, int vflag) make_rho_g(); - gc6->reverse_comm_kspace(this,1,sizeof(FFT_SCALAR),REVERSE_RHO_GEOM, - gc6_buf1,gc6_buf2,MPI_FFT_SCALAR); + gc6->reverse_comm(this,1,sizeof(FFT_SCALAR),REVERSE_RHO_GEOM, + gc6_buf1,gc6_buf2,MPI_FFT_SCALAR); brick2fft(nxlo_in_6,nylo_in_6,nzlo_in_6,nxhi_in_6,nyhi_in_6,nzhi_in_6, density_brick_g,density_fft_g,work1_6,remap_6); @@ -1004,14 +1004,14 @@ void PPPMDisp::compute(int eflag, int vflag) u_brick_g,v0_brick_g,v1_brick_g,v2_brick_g, v3_brick_g,v4_brick_g,v5_brick_g); - gc6->forward_comm_kspace(this,1,sizeof(FFT_SCALAR),FORWARD_AD_GEOM, - gc6_buf1,gc6_buf2,MPI_FFT_SCALAR); + gc6->forward_comm(this,1,sizeof(FFT_SCALAR),FORWARD_AD_GEOM, + gc6_buf1,gc6_buf2,MPI_FFT_SCALAR); fieldforce_g_ad(); if (vflag_atom) - gc6->forward_comm_kspace(this,6,sizeof(FFT_SCALAR),FORWARD_AD_PERATOM_GEOM, - gc6_buf1,gc6_buf2,MPI_FFT_SCALAR); + gc6->forward_comm(this,6,sizeof(FFT_SCALAR),FORWARD_AD_PERATOM_GEOM, + gc6_buf1,gc6_buf2,MPI_FFT_SCALAR); } else { poisson_ik(work1_6,work2_6,density_fft_g,fft1_6,fft2_6, @@ -1024,14 +1024,14 @@ void PPPMDisp::compute(int eflag, int vflag) u_brick_g,v0_brick_g,v1_brick_g,v2_brick_g, v3_brick_g,v4_brick_g,v5_brick_g); - gc6->forward_comm_kspace(this,3,sizeof(FFT_SCALAR),FORWARD_IK_GEOM, - gc6_buf1,gc6_buf2,MPI_FFT_SCALAR); + gc6->forward_comm(this,3,sizeof(FFT_SCALAR),FORWARD_IK_GEOM, + gc6_buf1,gc6_buf2,MPI_FFT_SCALAR); fieldforce_g_ik(); if (evflag_atom) - gc6->forward_comm_kspace(this,7,sizeof(FFT_SCALAR),FORWARD_IK_PERATOM_GEOM, - gc6_buf1,gc6_buf2,MPI_FFT_SCALAR); + gc6->forward_comm(this,7,sizeof(FFT_SCALAR),FORWARD_IK_PERATOM_GEOM, + gc6_buf1,gc6_buf2,MPI_FFT_SCALAR); } if (evflag_atom) fieldforce_g_peratom(); @@ -1048,8 +1048,8 @@ void PPPMDisp::compute(int eflag, int vflag) make_rho_a(); - gc6->reverse_comm_kspace(this,7,sizeof(FFT_SCALAR),REVERSE_RHO_ARITH, - gc6_buf1,gc6_buf2,MPI_FFT_SCALAR); + gc6->reverse_comm(this,7,sizeof(FFT_SCALAR),REVERSE_RHO_ARITH, + gc6_buf1,gc6_buf2,MPI_FFT_SCALAR); brick2fft_a(); @@ -1078,14 +1078,14 @@ void PPPMDisp::compute(int eflag, int vflag) u_brick_a4,v0_brick_a4,v1_brick_a4,v2_brick_a4, v3_brick_a4,v4_brick_a4,v5_brick_a4); - gc6->forward_comm_kspace(this,7,sizeof(FFT_SCALAR),FORWARD_AD_ARITH, - gc6_buf1,gc6_buf2,MPI_FFT_SCALAR); + gc6->forward_comm(this,7,sizeof(FFT_SCALAR),FORWARD_AD_ARITH, + gc6_buf1,gc6_buf2,MPI_FFT_SCALAR); fieldforce_a_ad(); if (evflag_atom) - gc6->forward_comm_kspace(this,42,sizeof(FFT_SCALAR),FORWARD_AD_PERATOM_ARITH, - gc6_buf1,gc6_buf2,MPI_FFT_SCALAR); + gc6->forward_comm(this,42,sizeof(FFT_SCALAR),FORWARD_AD_PERATOM_ARITH, + gc6_buf1,gc6_buf2,MPI_FFT_SCALAR); } else { poisson_ik(work1_6,work2_6,density_fft_a3,fft1_6,fft2_6, @@ -1119,14 +1119,14 @@ void PPPMDisp::compute(int eflag, int vflag) u_brick_a4,v0_brick_a4,v1_brick_a4,v2_brick_a4, v3_brick_a4,v4_brick_a4,v5_brick_a4); - gc6->forward_comm_kspace(this,21,sizeof(FFT_SCALAR),FORWARD_IK_ARITH, - gc6_buf1,gc6_buf2,MPI_FFT_SCALAR); + gc6->forward_comm(this,21,sizeof(FFT_SCALAR),FORWARD_IK_ARITH, + gc6_buf1,gc6_buf2,MPI_FFT_SCALAR); fieldforce_a_ik(); if (evflag_atom) - gc6->forward_comm_kspace(this,49,sizeof(FFT_SCALAR),FORWARD_IK_PERATOM_ARITH, - gc6_buf1,gc6_buf2,MPI_FFT_SCALAR); + gc6->forward_comm(this,49,sizeof(FFT_SCALAR),FORWARD_IK_PERATOM_ARITH, + gc6_buf1,gc6_buf2,MPI_FFT_SCALAR); } if (evflag_atom) fieldforce_a_peratom(); @@ -1143,8 +1143,8 @@ void PPPMDisp::compute(int eflag, int vflag) make_rho_none(); - gc6->reverse_comm_kspace(this,nsplit_alloc,sizeof(FFT_SCALAR),REVERSE_RHO_NONE, - gc6_buf1,gc6_buf2,MPI_FFT_SCALAR); + gc6->reverse_comm(this,nsplit_alloc,sizeof(FFT_SCALAR),REVERSE_RHO_NONE, + gc6_buf1,gc6_buf2,MPI_FFT_SCALAR); brick2fft_none(); @@ -1158,16 +1158,16 @@ void PPPMDisp::compute(int eflag, int vflag) n += 2; } - gc6->forward_comm_kspace(this,1*nsplit_alloc,sizeof(FFT_SCALAR), - FORWARD_AD_NONE, - gc6_buf1,gc6_buf2,MPI_FFT_SCALAR); + gc6->forward_comm(this,1*nsplit_alloc,sizeof(FFT_SCALAR), + FORWARD_AD_NONE, + gc6_buf1,gc6_buf2,MPI_FFT_SCALAR); fieldforce_none_ad(); if (vflag_atom) - gc6->forward_comm_kspace(this,6*nsplit_alloc,sizeof(FFT_SCALAR), - FORWARD_AD_PERATOM_NONE, - gc6_buf1,gc6_buf2,MPI_FFT_SCALAR); + gc6->forward_comm(this,6*nsplit_alloc,sizeof(FFT_SCALAR), + FORWARD_AD_PERATOM_NONE, + gc6_buf1,gc6_buf2,MPI_FFT_SCALAR); } else { int n = 0; @@ -1180,16 +1180,16 @@ void PPPMDisp::compute(int eflag, int vflag) n += 2; } - gc6->forward_comm_kspace(this,3*nsplit_alloc,sizeof(FFT_SCALAR), - FORWARD_IK_NONE, - gc6_buf1,gc6_buf2,MPI_FFT_SCALAR); + gc6->forward_comm(this,3*nsplit_alloc,sizeof(FFT_SCALAR), + FORWARD_IK_NONE, + gc6_buf1,gc6_buf2,MPI_FFT_SCALAR); fieldforce_none_ik(); if (evflag_atom) - gc6->forward_comm_kspace(this,7*nsplit_alloc,sizeof(FFT_SCALAR), - FORWARD_IK_PERATOM_NONE, - gc6_buf1,gc6_buf2,MPI_FFT_SCALAR); + gc6->forward_comm(this,7*nsplit_alloc,sizeof(FFT_SCALAR), + FORWARD_IK_PERATOM_NONE, + gc6_buf1,gc6_buf2,MPI_FFT_SCALAR); } if (evflag_atom) fieldforce_none_peratom(); diff --git a/src/KSPACE/pppm_stagger.cpp b/src/KSPACE/pppm_stagger.cpp index 49cefac12e..e233f1d3b0 100644 --- a/src/KSPACE/pppm_stagger.cpp +++ b/src/KSPACE/pppm_stagger.cpp @@ -157,8 +157,8 @@ void PPPMStagger::compute(int eflag, int vflag) // to fully sum contribution in their 3d bricks // remap from 3d decomposition to FFT decomposition - gc->reverse_comm_kspace(this,1,sizeof(FFT_SCALAR),REVERSE_RHO, - gc_buf1,gc_buf2,MPI_FFT_SCALAR); + gc->reverse_comm(this,1,sizeof(FFT_SCALAR),REVERSE_RHO, + gc_buf1,gc_buf2,MPI_FFT_SCALAR); brick2fft(); // compute potential gradient on my FFT grid and @@ -172,21 +172,21 @@ void PPPMStagger::compute(int eflag, int vflag) // to fill ghost cells surrounding their 3d bricks if (differentiation_flag == 1) - gc->forward_comm_kspace(this,1,sizeof(FFT_SCALAR),FORWARD_AD, - gc_buf1,gc_buf2,MPI_FFT_SCALAR); + gc->forward_comm(this,1,sizeof(FFT_SCALAR),FORWARD_AD, + gc_buf1,gc_buf2,MPI_FFT_SCALAR); else - gc->forward_comm_kspace(this,3,sizeof(FFT_SCALAR),FORWARD_IK, - gc_buf1,gc_buf2,MPI_FFT_SCALAR); + gc->forward_comm(this,3,sizeof(FFT_SCALAR),FORWARD_IK, + gc_buf1,gc_buf2,MPI_FFT_SCALAR); // extra per-atom energy/virial communication if (evflag_atom) { if (differentiation_flag == 1 && vflag_atom) - gc->forward_comm_kspace(this,6,sizeof(FFT_SCALAR),FORWARD_AD_PERATOM, - gc_buf1,gc_buf2,MPI_FFT_SCALAR); + gc->forward_comm(this,6,sizeof(FFT_SCALAR),FORWARD_AD_PERATOM, + gc_buf1,gc_buf2,MPI_FFT_SCALAR); else if (differentiation_flag == 0) - gc->forward_comm_kspace(this,7,sizeof(FFT_SCALAR),FORWARD_IK_PERATOM, - gc_buf1,gc_buf2,MPI_FFT_SCALAR); + gc->forward_comm(this,7,sizeof(FFT_SCALAR),FORWARD_IK_PERATOM, + gc_buf1,gc_buf2,MPI_FFT_SCALAR); } // calculate the force on my particles diff --git a/src/Makefile b/src/Makefile index 4e6fb5cea9..49f246f40f 100644 --- a/src/Makefile +++ b/src/Makefile @@ -49,6 +49,7 @@ endif PACKAGE = \ adios \ + amoeba \ asphere \ awpmd \ bocs \ diff --git a/src/angle.cpp b/src/angle.cpp index d822418141..b3b8066a03 100644 --- a/src/angle.cpp +++ b/src/angle.cpp @@ -25,6 +25,8 @@ using namespace LAMMPS_NS; using namespace MathConst; +#define FOURTH 0.25 + /* ---------------------------------------------------------------------- */ Angle::Angle(LAMMPS *lmp) : Pointers(lmp) @@ -221,30 +223,16 @@ void Angle::ev_tally(int i, int j, int k, int nlocal, int newton_bond, virial[4] += v[4]; virial[5] += v[5]; } else { - if (i < nlocal) { - virial[0] += THIRD*v[0]; - virial[1] += THIRD*v[1]; - virial[2] += THIRD*v[2]; - virial[3] += THIRD*v[3]; - virial[4] += THIRD*v[4]; - virial[5] += THIRD*v[5]; - } - if (j < nlocal) { - virial[0] += THIRD*v[0]; - virial[1] += THIRD*v[1]; - virial[2] += THIRD*v[2]; - virial[3] += THIRD*v[3]; - virial[4] += THIRD*v[4]; - virial[5] += THIRD*v[5]; - } - if (k < nlocal) { - virial[0] += THIRD*v[0]; - virial[1] += THIRD*v[1]; - virial[2] += THIRD*v[2]; - virial[3] += THIRD*v[3]; - virial[4] += THIRD*v[4]; - virial[5] += THIRD*v[5]; - } + double prefactor = 0.0; + if (i < nlocal) prefactor += 1.0; + if (j < nlocal) prefactor += 1.0; + if (k < nlocal) prefactor += 1.0; + virial[0] += prefactor*THIRD*v[0]; + virial[1] += prefactor*THIRD*v[1]; + virial[2] += prefactor*THIRD*v[2]; + virial[3] += prefactor*THIRD*v[3]; + virial[4] += prefactor*THIRD*v[4]; + virial[5] += prefactor*THIRD*v[5]; } } @@ -277,6 +265,7 @@ void Angle::ev_tally(int i, int j, int k, int nlocal, int newton_bond, } // per-atom centroid virial + if (cvflag_atom) { // r0 = (r1+r2+r3)/3 @@ -303,6 +292,7 @@ void Angle::ev_tally(int i, int j, int k, int nlocal, int newton_bond, cvatom[i][7] += a1[2]*f1[0]; cvatom[i][8] += a1[2]*f1[1]; } + if (newton_bond || j < nlocal) { double a2[3]; double f2[3]; @@ -326,6 +316,7 @@ void Angle::ev_tally(int i, int j, int k, int nlocal, int newton_bond, cvatom[j][7] += a2[2]*f2[0]; cvatom[j][8] += a2[2]*f2[1]; } + if (newton_bond || k < nlocal) { double a3[3]; @@ -347,6 +338,105 @@ void Angle::ev_tally(int i, int j, int k, int nlocal, int newton_bond, } } +/* ---------------------------------------------------------------------- + tally energy and virial into global and per-atom accumulators + virial = r1F1 + r2F2 + r3F3 + r4F4 +------------------------------------------------------------------------- */ + +void Angle::ev_tally4(int i, int j, int k, int m, int nlocal, int newton_bond, + double eangle, + double *f1, double *f2, double *f3, double *f4) +{ + double eanglefourth,v[6]; + + if (eflag_either) { + if (eflag_global) { + if (newton_bond) energy += eangle; + else { + eanglefourth = FOURTH*eangle; + if (i < nlocal) energy += eanglefourth; + if (j < nlocal) energy += eanglefourth; + if (k < nlocal) energy += eanglefourth; + } + } + if (eflag_atom) { + eanglefourth = FOURTH*eangle; + if (newton_bond || i < nlocal) eatom[i] += eanglefourth; + if (newton_bond || j < nlocal) eatom[j] += eanglefourth; + if (newton_bond || k < nlocal) eatom[k] += eanglefourth; + if (newton_bond || m < nlocal) eatom[m] += eanglefourth; + } + } + + if (vflag_either) { + double **x = atom->x; + v[0] = x[i][0]*f1[0] + x[j][0]*f2[0] + x[k][0]*f3[0] + x[m][0]*f4[0]; + v[1] = x[i][1]*f1[1] + x[j][1]*f2[1] + x[k][1]*f3[1] + x[m][1]*f4[1]; + v[2] = x[i][2]*f1[2] + x[j][2]*f2[2] + x[k][2]*f3[2] + x[m][2]*f4[2]; + v[3] = x[i][0]*f1[1] + x[j][0]*f2[1] + x[k][0]*f3[1] + x[m][0]*f4[1]; + v[4] = x[i][0]*f1[2] + x[j][0]*f2[2] + x[k][0]*f3[2] + x[m][0]*f4[2]; + v[5] = x[i][1]*f1[2] + x[j][1]*f2[2] + x[k][1]*f3[2] + x[m][1]*f4[2]; + + if (vflag_global) { + if (newton_bond) { + virial[0] += v[0]; + virial[1] += v[1]; + virial[2] += v[2]; + virial[3] += v[3]; + virial[4] += v[4]; + virial[5] += v[5]; + } else { + double prefactor = 0.0; + if (i < nlocal) prefactor += 1.0; + if (j < nlocal) prefactor += 1.0; + if (k < nlocal) prefactor += 1.0; + if (m < nlocal) prefactor += 1.0; + virial[0] += prefactor*FOURTH*v[0]; + virial[1] += prefactor*FOURTH*v[1]; + virial[2] += prefactor*FOURTH*v[2]; + virial[3] += prefactor*FOURTH*v[3]; + virial[4] += prefactor*FOURTH*v[4]; + virial[5] += prefactor*FOURTH*v[5]; + } + } + + if (vflag_atom) { + if (newton_bond || i < nlocal) { + vatom[i][0] += FOURTH*v[0]; + vatom[i][1] += FOURTH*v[1]; + vatom[i][2] += FOURTH*v[2]; + vatom[i][3] += FOURTH*v[3]; + vatom[i][4] += FOURTH*v[4]; + vatom[i][5] += FOURTH*v[5]; + } + if (newton_bond || j < nlocal) { + vatom[j][0] += FOURTH*v[0]; + vatom[j][1] += FOURTH*v[1]; + vatom[j][2] += FOURTH*v[2]; + vatom[j][3] += FOURTH*v[3]; + vatom[j][4] += FOURTH*v[4]; + vatom[j][5] += FOURTH*v[5]; + } + if (newton_bond || k < nlocal) { + vatom[k][0] += FOURTH*v[0]; + vatom[k][1] += FOURTH*v[1]; + vatom[k][2] += FOURTH*v[2]; + vatom[k][3] += FOURTH*v[3]; + vatom[k][4] += FOURTH*v[4]; + vatom[k][5] += FOURTH*v[5]; + } + if (newton_bond || m < nlocal) { + vatom[m][0] += FOURTH*v[0]; + vatom[m][1] += FOURTH*v[1]; + vatom[m][2] += FOURTH*v[2]; + vatom[m][3] += FOURTH*v[3]; + vatom[m][4] += FOURTH*v[4]; + vatom[m][5] += FOURTH*v[5]; + } + } + } +} + /* ---------------------------------------------------------------------- */ double Angle::memory_usage() diff --git a/src/angle.h b/src/angle.h index 3a6521003e..434986e042 100644 --- a/src/angle.h +++ b/src/angle.h @@ -77,6 +77,7 @@ class Angle : protected Pointers { void ev_setup(int, int, int alloc = 1); void ev_tally(int, int, int, int, int, double, double *, double *, double, double, double, double, double, double); + void ev_tally4(int, int, int, int, int, int, double, double *, double *, double *, double *); }; } // namespace LAMMPS_NS diff --git a/src/atom.cpp b/src/atom.cpp index 4135298673..86e2b1151b 100644 --- a/src/atom.cpp +++ b/src/atom.cpp @@ -203,6 +203,12 @@ Atom::Atom(LAMMPS *lmp) : Pointers(lmp) rho = drho = esph = desph = cv = nullptr; vest = nullptr; + // AMOEBA package + + maxspecial15 = 1; + nspecial15 = nullptr; + special15 = nullptr; + // DIELECTRIC package area = ed = em = epsilon = curvature = q_unscaled = nullptr; @@ -539,6 +545,11 @@ void Atom::peratom_create() add_peratom("eff_plastic_strain_rate",&eff_plastic_strain_rate,DOUBLE,0); add_peratom("damage",&damage,DOUBLE,0); + // AMOEBA package + + add_peratom("nspecial15",&nspecial15,INT,0); + add_peratom_vary("special15",&special15,tagintsize,&maxspecial15,&nspecial15,0); + // DIELECTRIC package add_peratom("area",&area,DOUBLE,0); @@ -654,7 +665,8 @@ void Atom::set_atomflag_defaults() mesont_flag = 0; contact_radius_flag = smd_data_9_flag = smd_stress_flag = 0; eff_plastic_strain_flag = eff_plastic_strain_rate_flag = 0; - + nspecial15_flag = 0; + pdscale = 1.0; } diff --git a/src/atom.h b/src/atom.h index e196d2d135..6389e688f6 100644 --- a/src/atom.h +++ b/src/atom.h @@ -161,6 +161,12 @@ class Atom : protected Pointers { double *rho, *drho, *esph, *desph, *cv; double **vest; + // AMOEBA package + + int *nspecial15; // # of 1-5 neighs + tagint **special15; // IDs of 1-5 neighs of each atom + int maxspecial15; // special15[nlocal][maxspecial15] + // DIELECTRIC package double *area, *ed, *em, *epsilon, *curvature, *q_unscaled; @@ -198,6 +204,10 @@ class Atom : protected Pointers { int contact_radius_flag, smd_data_9_flag, smd_stress_flag; int eff_plastic_strain_flag, eff_plastic_strain_rate_flag; + // AMOEBA package + + int nspecial15_flag; + // Peridynamics scale factor, used by dump cfg double pdscale; diff --git a/src/fix_property_atom.cpp b/src/fix_property_atom.cpp index 7df49f4bc4..e57046f638 100644 --- a/src/fix_property_atom.cpp +++ b/src/fix_property_atom.cpp @@ -31,7 +31,7 @@ enum{MOLECULE,CHARGE,RMASS,IVEC,DVEC,IARRAY,DARRAY}; FixPropertyAtom::FixPropertyAtom(LAMMPS *lmp, int narg, char **arg) : Fix(lmp, narg, arg), - nvalue(0), style(nullptr), index(nullptr), astyle(nullptr) + nvalue(0), styles(nullptr), index(nullptr), astyle(nullptr) { if (narg < 4) error->all(FLERR,"Illegal fix property/atom command"); @@ -40,7 +40,7 @@ FixPropertyAtom::FixPropertyAtom(LAMMPS *lmp, int narg, char **arg) : int iarg = 3; nvalue = narg-iarg; - style = new int[nvalue]; + styles = new int[nvalue]; cols = new int[nvalue]; index = new int[nvalue]; @@ -58,7 +58,7 @@ FixPropertyAtom::FixPropertyAtom(LAMMPS *lmp, int narg, char **arg) : "already has molecule attribute"); if (molecule_flag) error->all(FLERR,"Fix property/atom cannot specify mol twice"); - style[nvalue] = MOLECULE; + styles[nvalue] = MOLECULE; cols[nvalue] = 0; atom->molecule_flag = molecule_flag = 1; values_peratom++; @@ -69,7 +69,7 @@ FixPropertyAtom::FixPropertyAtom(LAMMPS *lmp, int narg, char **arg) : error->all(FLERR,"Fix property/atom q when atom_style already has charge attribute"); if (q_flag) error->all(FLERR,"Fix property/atom cannot specify q twice"); - style[nvalue] = CHARGE; + styles[nvalue] = CHARGE; cols[nvalue] = 0; atom->q_flag = q_flag = 1; values_peratom++; @@ -80,7 +80,7 @@ FixPropertyAtom::FixPropertyAtom(LAMMPS *lmp, int narg, char **arg) : error->all(FLERR,"Fix property/atom rmass when atom_style already has rmass attribute"); if (rmass_flag) error->all(FLERR,"Fix property/atom cannot specify rmass twice"); - style[nvalue] = RMASS; + styles[nvalue] = RMASS; cols[nvalue] = 0; atom->rmass_flag = rmass_flag = 1; values_peratom++; @@ -90,7 +90,7 @@ FixPropertyAtom::FixPropertyAtom(LAMMPS *lmp, int narg, char **arg) : // custom atom vector } else if (utils::strmatch(arg[iarg],"^i_")) { - style[nvalue] = IVEC; + styles[nvalue] = IVEC; int flag,ncols; index[nvalue] = atom->find_custom(&arg[iarg][2],flag,ncols); if (index[nvalue] >= 0) @@ -102,7 +102,7 @@ FixPropertyAtom::FixPropertyAtom(LAMMPS *lmp, int narg, char **arg) : iarg++; } else if (utils::strmatch(arg[iarg],"^d_")) { - style[nvalue] = DVEC; + styles[nvalue] = DVEC; int flag,ncols; index[nvalue] = atom->find_custom(&arg[iarg][2],flag,ncols); if (index[nvalue] >= 0) @@ -129,10 +129,10 @@ FixPropertyAtom::FixPropertyAtom(LAMMPS *lmp, int narg, char **arg) : if (arg[iarg][0] == 'i') { which = 0; - style[nvalue] = IARRAY; + styles[nvalue] = IARRAY; } else { which = 1; - style[nvalue] = DARRAY; + styles[nvalue] = DARRAY; } index[nvalue] = atom->add_custom(&arg[iarg][3],which,ncols); cols[nvalue] = ncols; @@ -165,9 +165,8 @@ FixPropertyAtom::FixPropertyAtom(LAMMPS *lmp, int narg, char **arg) : if (border == 0) { int flag = 0; for (int i = 0; i < nvalue; i++) - if (style[i] == MOLECULE - || style[i] == CHARGE - || style[i] == RMASS) flag = 1; + if (styles[i] == MOLECULE || styles[i] == CHARGE || styles[i] == RMASS) + flag = 1; if (flag && comm->me == 0) error->warning(FLERR,"Fix property/atom mol or charge or rmass " "w/out ghost communication"); @@ -201,25 +200,25 @@ FixPropertyAtom::~FixPropertyAtom() // set ptrs to a null pointer, so they no longer exist for Atom class for (int nv = 0; nv < nvalue; nv++) { - if (style[nv] == MOLECULE) { + if (styles[nv] == MOLECULE) { atom->molecule_flag = 0; memory->destroy(atom->molecule); atom->molecule = nullptr; - } else if (style[nv] == CHARGE) { + } else if (styles[nv] == CHARGE) { atom->q_flag = 0; memory->destroy(atom->q); atom->q = nullptr; - } else if (style[nv] == RMASS) { + } else if (styles[nv] == RMASS) { atom->rmass_flag = 0; memory->destroy(atom->rmass); atom->rmass = nullptr; - } else if (style[nv] == IVEC) { + } else if (styles[nv] == IVEC) { atom->remove_custom(index[nv],0,cols[nv]); - } else if (style[nv] == DVEC) { + } else if (styles[nv] == DVEC) { atom->remove_custom(index[nv],1,cols[nv]); - } else if (style[nv] == IARRAY) { + } else if (styles[nv] == IARRAY) { atom->remove_custom(index[nv],0,cols[nv]); - } else if (style[nv] == DARRAY) { + } else if (styles[nv] == DARRAY) { atom->remove_custom(index[nv],1,cols[nv]); } } @@ -291,21 +290,21 @@ void FixPropertyAtom::read_data_section(char *keyword, int n, char *buf, tagint if ((m = atom->map(itag)) >= 0) { for (j = 0; j < nvalue; j++) { - if (style[j] == MOLECULE) { + if (styles[j] == MOLECULE) { atom->molecule[m] = values.next_tagint(); - } else if (style[j] == CHARGE) { + } else if (styles[j] == CHARGE) { atom->q[m] = values.next_double(); - } else if (style[j] == RMASS) { + } else if (styles[j] == RMASS) { atom->rmass[m] = values.next_double(); - } else if (style[j] == IVEC) { + } else if (styles[j] == IVEC) { atom->ivector[index[j]][m] = values.next_int(); - } else if (style[j] == DVEC) { + } else if (styles[j] == DVEC) { atom->dvector[index[j]][m] = values.next_double(); - } else if (style[j] == IARRAY) { + } else if (styles[j] == IARRAY) { ncol = cols[j]; for (k = 0; k < ncol; k++) atom->iarray[index[j]][m][k] = values.next_int(); - } else if (style[j] == DARRAY) { + } else if (styles[j] == DARRAY) { ncol = cols[j]; for (k = 0; k < ncol; k++) atom->darray[index[j]][m][k] = values.next_double(); @@ -365,34 +364,34 @@ void FixPropertyAtom::write_data_section_pack(int /*mth*/, double **buf) int icol = 1; for (int nv = 0; nv < nvalue; nv++) { - if (style[nv] == MOLECULE) { + if (styles[nv] == MOLECULE) { tagint *molecule = atom->molecule; for (i = 0; i < nlocal; i++) buf[i][icol] = ubuf(molecule[i]).d; icol++; - } else if (style[nv] == CHARGE) { + } else if (styles[nv] == CHARGE) { double *q = atom->q; for (i = 0; i < nlocal; i++) buf[i][icol] = q[i]; icol++; - } else if (style[nv] == RMASS) { + } else if (styles[nv] == RMASS) { double *rmass = atom->rmass; for (i = 0; i < nlocal; i++) buf[i][icol] = rmass[i]; icol++; - } else if (style[nv] == IVEC) { + } else if (styles[nv] == IVEC) { int *ivec = atom->ivector[index[nv]]; for (i = 0; i < nlocal; i++) buf[i][icol] = ubuf(ivec[i]).d; icol++; - } else if (style[nv] == DVEC) { + } else if (styles[nv] == DVEC) { double *dvec = atom->dvector[index[nv]]; for (i = 0; i < nlocal; i++) buf[i][icol] = dvec[i]; icol++; - } else if (style[nv] == IARRAY) { + } else if (styles[nv] == IARRAY) { int **iarray = atom->iarray[index[nv]]; ncol = cols[nv]; for (i = 0; i < nlocal; i++) for (k = 0; k < ncol; k++) buf[i][icol+k] = ubuf(iarray[i][k]).d; icol += ncol; - } else if (style[nv] == DARRAY) { + } else if (styles[nv] == DARRAY) { double **darray = atom->darray[index[nv]]; ncol = cols[nv]; for (i = 0; i < nlocal; i++) @@ -412,19 +411,19 @@ void FixPropertyAtom::write_data_section_pack(int /*mth*/, double **buf) void FixPropertyAtom::write_data_section_keyword(int /*mth*/, FILE *fp) { - if (nvalue == 1 && style[0] == MOLECULE) fprintf(fp,"\nMolecules\n\n"); - else if (nvalue == 1 && style[0] == CHARGE) fprintf(fp,"\nCharges\n\n"); + if (nvalue == 1 && styles[0] == MOLECULE) fprintf(fp,"\nMolecules\n\n"); + else if (nvalue == 1 && styles[0] == CHARGE) fprintf(fp,"\nCharges\n\n"); else { fprintf(fp,"\n%s #",id); // write column hint as comment for (int i = 0; i < nvalue; ++i) { - if (style[i] == MOLECULE) fputs(" mol",fp); - else if (style[i] == CHARGE) fputs(" q",fp); - else if (style[i] == RMASS) fputs(" rmass",fp); - else if (style[i] == IVEC) fprintf(fp," i_%s", atom->ivname[index[i]]); - else if (style[i] == DVEC) fprintf(fp, " d_%s", atom->dvname[index[i]]); - else if (style[i] == IARRAY) fprintf(fp, " i_%s", atom->ianame[index[i]]); - else if (style[i] == DARRAY) fprintf(fp, " d_%s", atom->daname[index[i]]); + if (styles[i] == MOLECULE) fputs(" mol",fp); + else if (styles[i] == CHARGE) fputs(" q",fp); + else if (styles[i] == RMASS) fputs(" rmass",fp); + else if (styles[i] == IVEC) fprintf(fp," i_%s", atom->ivname[index[i]]); + else if (styles[i] == DVEC) fprintf(fp, " d_%s", atom->dvname[index[i]]); + else if (styles[i] == IARRAY) fprintf(fp, " i_%s", atom->ianame[index[i]]); + else if (styles[i] == DARRAY) fprintf(fp, " d_%s", atom->daname[index[i]]); } fputs("\n\n",fp); } @@ -446,22 +445,22 @@ void FixPropertyAtom::write_data_section(int /*mth*/, FILE *fp, fprintf(fp,TAGINT_FORMAT,(tagint) ubuf(buf[i][0]).i); icol = 1; for (nv = 0; nv < nvalue; nv++) { - if (style[nv] == MOLECULE) + if (styles[nv] == MOLECULE) fprintf(fp," " TAGINT_FORMAT,(tagint) ubuf(buf[i][icol++]).i); - else if (style[nv] == CHARGE) + else if (styles[nv] == CHARGE) fprintf(fp," %g",buf[i][icol++]); - else if (style[nv] == RMASS) + else if (styles[nv] == RMASS) fprintf(fp," %g",buf[i][icol++]); - else if (style[nv] == IVEC) + else if (styles[nv] == IVEC) fprintf(fp," %d",(int) ubuf(buf[i][icol++]).i); - else if (style[nv] == DVEC) + else if (styles[nv] == DVEC) fprintf(fp," %g",buf[i][icol++]); - else if (style[nv] == IARRAY) { + else if (styles[nv] == IARRAY) { ncol = cols[nv]; for (k = 0; k < ncol; k++) fprintf(fp," %d",(int) ubuf(buf[i][icol+k]).i); icol += ncol; - } else if (style[nv] == DARRAY) { + } else if (styles[nv] == DARRAY) { ncol = cols[nv]; for (k = 0; k < ncol; k++) fprintf(fp," %g",buf[i][icol+k]); @@ -480,13 +479,13 @@ double FixPropertyAtom::memory_usage() { double bytes = 0.0; for (int m = 0; m < nvalue; m++) { - if (style[m] == MOLECULE) bytes = atom->nmax * sizeof(tagint); - else if (style[m] == CHARGE) bytes = atom->nmax * sizeof(double); - else if (style[m] == RMASS) bytes = atom->nmax * sizeof(double); - else if (style[m] == IVEC) bytes = atom->nmax * sizeof(int); - else if (style[m] == DVEC) bytes = atom->nmax * sizeof(double); - else if (style[m] == IARRAY) bytes = atom->nmax * cols[m] * sizeof(int); - else if (style[m] == DARRAY) bytes = atom->nmax * cols[m] * sizeof(double); + if (styles[m] == MOLECULE) bytes = atom->nmax * sizeof(tagint); + else if (styles[m] == CHARGE) bytes = atom->nmax * sizeof(double); + else if (styles[m] == RMASS) bytes = atom->nmax * sizeof(double); + else if (styles[m] == IVEC) bytes = atom->nmax * sizeof(int); + else if (styles[m] == DVEC) bytes = atom->nmax * sizeof(double); + else if (styles[m] == IARRAY) bytes = atom->nmax * cols[m] * sizeof(int); + else if (styles[m] == DARRAY) bytes = atom->nmax * cols[m] * sizeof(double); } return bytes; } @@ -501,31 +500,31 @@ double FixPropertyAtom::memory_usage() void FixPropertyAtom::grow_arrays(int nmax) { for (int nv = 0; nv < nvalue; nv++) { - if (style[nv] == MOLECULE) { + if (styles[nv] == MOLECULE) { memory->grow(atom->molecule,nmax,"atom:molecule"); size_t nbytes = (nmax-nmax_old) * sizeof(tagint); memset(&atom->molecule[nmax_old],0,nbytes); - } else if (style[nv] == CHARGE) { + } else if (styles[nv] == CHARGE) { memory->grow(atom->q,nmax,"atom:q"); size_t nbytes = (nmax-nmax_old) * sizeof(double); memset(&atom->q[nmax_old],0,nbytes); - } else if (style[nv] == RMASS) { + } else if (styles[nv] == RMASS) { memory->grow(atom->rmass,nmax,"atom:rmass"); size_t nbytes = (nmax-nmax_old) * sizeof(double); memset(&atom->rmass[nmax_old],0,nbytes); - } else if (style[nv] == IVEC) { + } else if (styles[nv] == IVEC) { memory->grow(atom->ivector[index[nv]],nmax,"atom:ivector"); size_t nbytes = (nmax-nmax_old) * sizeof(int); memset(&atom->ivector[index[nv]][nmax_old],0,nbytes); - } else if (style[nv] == DVEC) { + } else if (styles[nv] == DVEC) { memory->grow(atom->dvector[index[nv]],nmax,"atom:dvector"); size_t nbytes = (nmax-nmax_old) * sizeof(double); memset(&atom->dvector[index[nv]][nmax_old],0,nbytes); - } else if (style[nv] == IARRAY) { + } else if (styles[nv] == IARRAY) { memory->grow(atom->iarray[index[nv]],nmax,cols[nv],"atom:iarray"); size_t nbytes = (nmax-nmax_old) * cols[nv] * sizeof(int); if (nbytes) memset(&atom->iarray[index[nv]][nmax_old][0],0,nbytes); - } else if (style[nv] == DARRAY) { + } else if (styles[nv] == DARRAY) { memory->grow(atom->darray[index[nv]],nmax,cols[nv],"atom:darray"); size_t nbytes = (nmax-nmax_old) * cols[nv] * sizeof(double); if (nbytes) memset(&atom->darray[index[nv]][nmax_old][0],0,nbytes); @@ -544,21 +543,21 @@ void FixPropertyAtom::copy_arrays(int i, int j, int /*delflag*/) int k,ncol; for (int nv = 0; nv < nvalue; nv++) { - if (style[nv] == MOLECULE) + if (styles[nv] == MOLECULE) atom->molecule[j] = atom->molecule[i]; - else if (style[nv] == CHARGE) + else if (styles[nv] == CHARGE) atom->q[j] = atom->q[i]; - else if (style[nv] == RMASS) + else if (styles[nv] == RMASS) atom->rmass[j] = atom->rmass[i]; - else if (style[nv] == IVEC) + else if (styles[nv] == IVEC) atom->ivector[index[nv]][j] = atom->ivector[index[nv]][i]; - else if (style[nv] == DVEC) + else if (styles[nv] == DVEC) atom->dvector[index[nv]][j] = atom->dvector[index[nv]][i]; - else if (style[nv] == IARRAY) { + else if (styles[nv] == IARRAY) { ncol = cols[nv]; for (k = 0; k < ncol; k++) atom->iarray[index[nv]][j][k] = atom->iarray[index[nv]][i][k]; - } else if (style[nv] == DARRAY) { + } else if (styles[nv] == DARRAY) { ncol = cols[nv]; for (k = 0; k < ncol; k++) atom->darray[index[nv]][j][k] = atom->darray[index[nv]][i][k]; @@ -576,37 +575,37 @@ int FixPropertyAtom::pack_border(int n, int *list, double *buf) int m = 0; for (int nv = 0; nv < nvalue; nv++) { - if (style[nv] == MOLECULE) { + if (styles[nv] == MOLECULE) { tagint *molecule = atom->molecule; for (i = 0; i < n; i++) { j = list[i]; buf[m++] = ubuf(molecule[j]).d; } - } else if (style[nv] == CHARGE) { + } else if (styles[nv] == CHARGE) { double *q = atom->q; for (i = 0; i < n; i++) { j = list[i]; buf[m++] = q[j]; } - } else if (style[nv] == RMASS) { + } else if (styles[nv] == RMASS) { double *rmass = atom->rmass; for (i = 0; i < n; i++) { j = list[i]; buf[m++] = rmass[j]; } - } else if (style[nv] == IVEC) { + } else if (styles[nv] == IVEC) { int *ivector = atom->ivector[index[nv]]; for (i = 0; i < n; i++) { j = list[i]; buf[m++] = ubuf(ivector[j]).d; } - } else if (style[nv] == DVEC) { + } else if (styles[nv] == DVEC) { double *dvector = atom->dvector[index[nv]]; for (i = 0; i < n; i++) { j = list[i]; buf[m++] = dvector[j]; } - } else if (style[nv] == IARRAY) { + } else if (styles[nv] == IARRAY) { int **iarray = atom->iarray[index[nv]]; ncol = cols[nv]; for (i = 0; i < n; i++) { @@ -614,7 +613,7 @@ int FixPropertyAtom::pack_border(int n, int *list, double *buf) for (k = 0; k < ncol; k++) buf[m++] = ubuf(iarray[j][k]).d; } - } else if (style[nv] == DARRAY) { + } else if (styles[nv] == DARRAY) { double **darray = atom->darray[index[nv]]; ncol = cols[nv]; for (i = 0; i < n; i++) { @@ -638,39 +637,39 @@ int FixPropertyAtom::unpack_border(int n, int first, double *buf) int m = 0; for (int nv = 0; nv < nvalue; nv++) { - if (style[nv] == MOLECULE) { + if (styles[nv] == MOLECULE) { tagint *molecule = atom->molecule; last = first + n; for (i = first; i < last; i++) molecule[i] = (tagint) ubuf(buf[m++]).i; - } else if (style[nv] == CHARGE) { + } else if (styles[nv] == CHARGE) { double *q = atom->q; last = first + n; for (i = first; i < last; i++) q[i] = buf[m++]; - } else if (style[nv] == RMASS) { + } else if (styles[nv] == RMASS) { double *rmass = atom->rmass; last = first + n; for (i = first; i < last; i++) rmass[i] = buf[m++]; - } else if (style[nv] == IVEC) { + } else if (styles[nv] == IVEC) { int *ivector = atom->ivector[index[nv]]; last = first + n; for (i = first; i < last; i++) ivector[i] = (int) ubuf(buf[m++]).i; - } else if (style[nv] == DVEC) { + } else if (styles[nv] == DVEC) { double *dvector = atom->dvector[index[nv]]; last = first + n; for (i = first; i < last; i++) dvector[i] = buf[m++]; - } else if (style[nv] == IARRAY) { + } else if (styles[nv] == IARRAY) { int **iarray = atom->iarray[index[nv]]; ncol = cols[nv]; last = first + n; for (i = first; i < last; i++) for (k = 0; k < ncol; k++) iarray[i][k] = (int) ubuf(buf[m++]).i; - } else if (style[nv] == DARRAY) { + } else if (styles[nv] == DARRAY) { double **darray = atom->darray[index[nv]]; ncol = cols[nv]; last = first + n; @@ -693,16 +692,16 @@ int FixPropertyAtom::pack_exchange(int i, double *buf) int m = 0; for (int nv = 0; nv < nvalue; nv++) { - if (style[nv] == MOLECULE) buf[m++] = ubuf(atom->molecule[i]).d; - else if (style[nv] == CHARGE) buf[m++] = atom->q[i]; - else if (style[nv] == RMASS) buf[m++] = atom->rmass[i]; - else if (style[nv] == IVEC) buf[m++] = ubuf(atom->ivector[index[nv]][i]).d; - else if (style[nv] == DVEC) buf[m++] = atom->dvector[index[nv]][i]; - else if (style[nv] == IARRAY) { + if (styles[nv] == MOLECULE) buf[m++] = ubuf(atom->molecule[i]).d; + else if (styles[nv] == CHARGE) buf[m++] = atom->q[i]; + else if (styles[nv] == RMASS) buf[m++] = atom->rmass[i]; + else if (styles[nv] == IVEC) buf[m++] = ubuf(atom->ivector[index[nv]][i]).d; + else if (styles[nv] == DVEC) buf[m++] = atom->dvector[index[nv]][i]; + else if (styles[nv] == IARRAY) { ncol = cols[nv]; for (k = 0; k < ncol; k++) buf[m++] = ubuf(atom->iarray[index[nv]][i][k]).d; - } else if (style[nv] == DARRAY) { + } else if (styles[nv] == DARRAY) { ncol = cols[nv]; for (k = 0; k < ncol; k++) buf[m++] = atom->darray[index[nv]][i][k]; @@ -722,21 +721,21 @@ int FixPropertyAtom::unpack_exchange(int nlocal, double *buf) int m = 0; for (int nv = 0; nv < nvalue; nv++) { - if (style[nv] == MOLECULE) + if (styles[nv] == MOLECULE) atom->molecule[nlocal] = (tagint) ubuf(buf[m++]).i; - else if (style[nv] == CHARGE) + else if (styles[nv] == CHARGE) atom->q[nlocal] = buf[m++]; - else if (style[nv] == RMASS) + else if (styles[nv] == RMASS) atom->rmass[nlocal] = buf[m++]; - else if (style[nv] == IVEC) + else if (styles[nv] == IVEC) atom->ivector[index[nv]][nlocal] = (int) ubuf(buf[m++]).i; - else if (style[nv] == DVEC) + else if (styles[nv] == DVEC) atom->dvector[index[nv]][nlocal] = buf[m++]; - else if (style[nv] == IARRAY) { + else if (styles[nv] == IARRAY) { ncol = cols[nv]; for (k = 0; k < ncol; k++) atom->iarray[index[nv]][nlocal][k] = (int) ubuf(buf[m++]).i; - } else if (style[nv] == DARRAY) { + } else if (styles[nv] == DARRAY) { ncol = cols[nv]; for (k = 0; k < ncol; k++) atom->darray[index[nv]][nlocal][k] = buf[m++]; @@ -760,16 +759,16 @@ int FixPropertyAtom::pack_restart(int i, double *buf) int m = 1; for (int nv = 0; nv < nvalue; nv++) { - if (style[nv] == MOLECULE) buf[m++] = ubuf(atom->molecule[i]).d; - else if (style[nv] == CHARGE) buf[m++] = atom->q[i]; - else if (style[nv] == RMASS) buf[m++] = atom->rmass[i]; - else if (style[nv] == IVEC) buf[m++] = ubuf(atom->ivector[index[nv]][i]).d; - else if (style[nv] == DVEC) buf[m++] = atom->dvector[index[nv]][i]; - else if (style[nv] == IARRAY) { + if (styles[nv] == MOLECULE) buf[m++] = ubuf(atom->molecule[i]).d; + else if (styles[nv] == CHARGE) buf[m++] = atom->q[i]; + else if (styles[nv] == RMASS) buf[m++] = atom->rmass[i]; + else if (styles[nv] == IVEC) buf[m++] = ubuf(atom->ivector[index[nv]][i]).d; + else if (styles[nv] == DVEC) buf[m++] = atom->dvector[index[nv]][i]; + else if (styles[nv] == IARRAY) { ncol = cols[nv]; for (k = 0; k < ncol; k++) buf[m++] = ubuf(atom->iarray[index[nv]][i][k]).d; - } else if (style[nv] == DARRAY) { + } else if (styles[nv] == DARRAY) { ncol = cols[nv]; for (k = 0; k < ncol; k++) buf[m++] = atom->darray[index[nv]][i][k]; @@ -796,21 +795,21 @@ void FixPropertyAtom::unpack_restart(int nlocal, int nth) m++; for (int nv = 0; nv < nvalue; nv++) { - if (style[nv] == MOLECULE) + if (styles[nv] == MOLECULE) atom->molecule[nlocal] = (tagint) ubuf(extra[nlocal][m++]).i; - else if (style[nv] == CHARGE) + else if (styles[nv] == CHARGE) atom->q[nlocal] = extra[nlocal][m++]; - else if (style[nv] == RMASS) + else if (styles[nv] == RMASS) atom->rmass[nlocal] = extra[nlocal][m++]; - else if (style[nv] == IVEC) + else if (styles[nv] == IVEC) atom->ivector[index[nv]][nlocal] = (int) ubuf(extra[nlocal][m++]).i; - else if (style[nv] == DVEC) + else if (styles[nv] == DVEC) atom->dvector[index[nv]][nlocal] = extra[nlocal][m++]; - else if (style[nv] == IARRAY) { + else if (styles[nv] == IARRAY) { ncol = cols[nv]; for (k = 0; k < ncol; k++) atom->iarray[index[nv]][nlocal][k] = (int) ubuf(extra[nlocal][m++]).i; - } else if (style[nv] == DARRAY) { + } else if (styles[nv] == DARRAY) { ncol = cols[nv]; for (k = 0; k < ncol; k++) atom->darray[index[nv]][nlocal][k] = extra[nlocal][m++]; diff --git a/src/fix_property_atom.h b/src/fix_property_atom.h index 08cee7d94c..8580865e59 100644 --- a/src/fix_property_atom.h +++ b/src/fix_property_atom.h @@ -53,7 +53,7 @@ class FixPropertyAtom : public Fix { protected: int nvalue, border; int molecule_flag, q_flag, rmass_flag; // flags for specific fields - int *style; // style of each value, see enum + int *styles; // style of each value, see enum int *index; // indices into atom custom data structs int *cols; // columns per value, for arrays char *astyle; // atom style at instantiation diff --git a/src/fix_store.cpp b/src/fix_store.cpp index e121cd8f08..351f4808b1 100644 --- a/src/fix_store.cpp +++ b/src/fix_store.cpp @@ -31,18 +31,17 @@ enum{UNKNOWN,GLOBAL,PERATOM}; FixStore::FixStore(LAMMPS *lmp, int narg, char **arg) : Fix(lmp, narg, arg), vstore(nullptr), astore(nullptr), rbuf(nullptr) { - if (narg != 6) error->all(FLERR,"Illegal fix store command"); + if (narg != 6 && narg != 7) error->all(FLERR,"Illegal fix store command"); // 4th arg determines GLOBAL vs PERATOM values - // syntax: id group style global nrow ncol - // Nrow by Ncol array of global values - // Ncol = 1 is vector, Ncol > 1 is array - // syntax: id group style peratom 0/1 nvalues + // global syntax: id group style global n1 n2 + // N2 = 1 is vector, N2 > 1 is array, no tensor allowed (yet) + // peratom syntax: id group style peratom 0/1 n1 n2 (n3), last arg optional // 0/1 flag = not-store or store peratom values in restart file + // N2 = 1 and no n3 is vector, N2 > 1 and no n3 is array, N3 = tensor // nvalues = # of peratom values, N = 1 is vector, N > 1 is array disable = 0; - nvalues = vecflag = 0; flavor = UNKNOWN; if (strcmp(arg[3],"global") == 0) flavor = GLOBAL; @@ -52,35 +51,48 @@ vstore(nullptr), astore(nullptr), rbuf(nullptr) // GLOBAL values are always written to restart file // PERATOM restart_peratom is set by caller + vecflag = arrayflag = tensorflag = 0; + if (flavor == GLOBAL) { restart_global = 1; - nrow = utils::inumeric(FLERR,arg[4],false,lmp); - ncol = utils::inumeric(FLERR,arg[5],false,lmp); - if (nrow <= 0 || ncol <= 0) - error->all(FLERR,"Illegal fix store command"); - vecflag = 0; - if (ncol == 1) vecflag = 1; + n1 = utils::inumeric(FLERR,arg[4],false,lmp); + n2 = utils::inumeric(FLERR,arg[5],false,lmp); + if (narg == 7) error->all(FLERR,"Illegal fix store command"); + if (n1 <= 0 || n2 <= 0) error->all(FLERR,"Illegal fix store command"); + if (n2 == 1) vecflag = 1; + else arrayflag = 1; + nrow = n1; + ncol = n2; } + if (flavor == PERATOM) { restart_peratom = utils::inumeric(FLERR,arg[4],false,lmp); - nvalues = utils::inumeric(FLERR,arg[5],false,lmp); - if (restart_peratom < 0 or restart_peratom > 1 || nvalues <= 0) + n2 = utils::inumeric(FLERR,arg[5],false,lmp); + if (narg == 7) n3 = utils::inumeric(FLERR,arg[6],false,lmp); + else n3 = 1; + if (restart_peratom < 0 || restart_peratom > 1) error->all(FLERR,"Illegal fix store command"); - vecflag = 0; - if (nvalues == 1) vecflag = 1; + if (n2 <= 0 || n3 <= 0) error->all(FLERR,"Illegal fix store command"); + if (n2 == 1 && narg == 6) vecflag = 1; + else if (narg == 6) arrayflag = 1; + else tensorflag = 1; + nvalues = n2*n3; + nbytes = n2*n3 * sizeof(double); } - vstore = nullptr; - astore = nullptr; + vstore = NULL; + astore = NULL; + tstore = NULL; - // allocate vector or array and restart buffer rbuf + // allocate data struct and restart buffer rbuf // for PERATOM, register with Atom class if (flavor == GLOBAL) { - if (vecflag) memory->create(vstore,nrow,"fix/store:vstore"); - else memory->create(astore,nrow,ncol,"fix/store:astore"); - memory->create(rbuf,nrow*ncol+2,"fix/store:rbuf"); + if (vecflag) memory->create(vstore,n1,"fix/store:vstore"); + else if (arrayflag) memory->create(astore,n1,n2,"fix/store:astore"); + memory->create(rbuf,n1*n2+2,"fix/store:rbuf"); } + if (flavor == PERATOM) { grow_arrays(atom->nmax); atom->add_callback(Atom::GROW); @@ -92,21 +104,31 @@ vstore(nullptr), astore(nullptr), rbuf(nullptr) // PERATOM may be comm->exchanged before filled by caller if (flavor == GLOBAL) { - if (vecflag) - for (int i = 0; i < nrow; i++) vstore[i] = 0.0; - else - for (int i = 0; i < nrow; i++) - for (int j = 0; j < ncol; j++) + if (vecflag) { + for (int i = 0; i < n1; i++) + vstore[i] = 0.0; + } else if (arrayflag) { + for (int i = 0; i < n1; i++) + for (int j = 0; j < n2; j++) astore[i][j] = 0.0; + } } + if (flavor == PERATOM) { int nlocal = atom->nlocal; - if (vecflag) - for (int i = 0; i < nlocal; i++) vstore[i] = 0.0; - else + if (vecflag) { + for (int i = 0; i < nlocal; i++) + vstore[i] = 0.0; + } else if (arrayflag) { for (int i = 0; i < nlocal; i++) - for (int j = 0; j < nvalues; j++) + for (int j = 0; j < n2; j++) astore[i][j] = 0.0; + } else if (tensorflag) { + for (int i = 0; i < nlocal; i++) + for (int j = 0; j < n2; j++) + for (int k = 0; k < n3; k++) + tstore[i][j][k] = 0.0; + } maxexchange = nvalues; } } @@ -124,6 +146,7 @@ FixStore::~FixStore() memory->destroy(vstore); memory->destroy(astore); + memory->destroy(tstore); memory->destroy(rbuf); } @@ -141,7 +164,7 @@ int FixStore::setmask() caller will do subsequent initialization ------------------------------------------------------------------------- */ -void FixStore::reset_global(int nrow_caller, int ncol_caller) + void FixStore::reset_global(int n1_caller, int n2_caller) { memory->destroy(vstore); memory->destroy(astore); @@ -149,29 +172,31 @@ void FixStore::reset_global(int nrow_caller, int ncol_caller) vstore = nullptr; astore = nullptr; - vecflag = 0; - if (ncol_caller == 1) vecflag = 1; - nrow = nrow_caller; - ncol = ncol_caller; - if (vecflag) memory->create(vstore,nrow,"fix/store:vstore"); - else memory->create(astore,nrow,ncol,"fix/store:astore"); - memory->create(rbuf,nrow*ncol+2,"fix/store:rbuf"); + vecflag = arrayflag = 0; + if (n2_caller == 1) vecflag = 1; + else arrayflag = 1; + + n1 = n1_caller; + n2 = n2_caller; + if (vecflag) memory->create(vstore,n1,"fix/store:vstore"); + else if (arrayflag) memory->create(astore,n1,n2,"fix/store:astore"); + memory->create(rbuf,n1*n2+2,"fix/store:rbuf"); } /* ---------------------------------------------------------------------- - write global array to restart file + write global vector/array to restart file ------------------------------------------------------------------------- */ void FixStore::write_restart(FILE *fp) { - // fill rbuf with size and vec/array values + // fill rbuf with size and vector/array values - rbuf[0] = nrow; - rbuf[1] = ncol; - if (vecflag) memcpy(&rbuf[2],vstore,sizeof(double)*nrow); - else memcpy(&rbuf[2],&astore[0][0],sizeof(double)*nrow*ncol); + rbuf[0] = n1; + rbuf[1] = n2; + if (vecflag) memcpy(&rbuf[2],vstore,n1*sizeof(double)); + else if (arrayflag) memcpy(&rbuf[2],&astore[0][0],n1*n2*sizeof(double)); - int n = nrow*ncol + 2; + int n = n1*n2 + 2; if (comm->me == 0) { int size = n * sizeof(double); fwrite(&size,sizeof(int),1,fp); @@ -188,33 +213,34 @@ void FixStore::restart(char *buf) // first 2 values in buf are vec/array sizes double *dbuf = (double *) buf; - int nrow_restart = dbuf[0]; - int ncol_restart = dbuf[1]; + int n1_restart = dbuf[0]; + int n2_restart = dbuf[1]; // if size of vec/array has changed, // means the restart file is setting size of vec or array and doing init // because caller did not know size at time this fix was instantiated // reallocate vstore or astore accordingly - if (nrow != nrow_restart || ncol != ncol_restart) { + if (n1 != n1_restart || n2 != n2_restart) { memory->destroy(vstore); memory->destroy(astore); memory->destroy(rbuf); vstore = nullptr; astore = nullptr; - vecflag = 0; - if (ncol_restart == 1) vecflag = 1; - nrow = nrow_restart; - ncol = ncol_restart; - if (vecflag) memory->create(vstore,nrow,"fix/store:vstore"); - else memory->create(astore,nrow,ncol,"fix/store:astore"); - memory->create(rbuf,nrow*ncol+2,"fix/store:rbuf"); + vecflag = arrayflag = 0; + if (n2_restart == 1) vecflag = 1; + else arrayflag = 1; + n1 = n1_restart; + n2 = n2_restart; + if (vecflag) memory->create(vstore,n1,"fix/store:vstore"); + else if (arrayflag) memory->create(astore,n1,n2,"fix/store:astore"); + memory->create(rbuf,n1*n2+2,"fix/store:rbuf"); } - int n = nrow*ncol; + int n = n1*n2; if (vecflag) memcpy(vstore,&dbuf[2],n*sizeof(double)); - else memcpy(&astore[0][0],&dbuf[2],n*sizeof(double)); + else if (arrayflag) memcpy(&astore[0][0],&dbuf[2],n*sizeof(double)); } /* ---------------------------------------------------------------------- @@ -224,7 +250,8 @@ void FixStore::restart(char *buf) void FixStore::grow_arrays(int nmax) { if (vecflag) memory->grow(vstore,nmax,"store:vstore"); - else memory->grow(astore,nmax,nvalues,"store:astore"); + else if (arrayflag) memory->grow(astore,nmax,n2,"store:astore"); + else if (tensorflag) memory->grow(tstore,nmax,n2,n3,"store:tstore"); } /* ---------------------------------------------------------------------- @@ -235,10 +262,14 @@ void FixStore::copy_arrays(int i, int j, int /*delflag*/) { if (disable) return; - if (vecflag) vstore[j] = vstore[i]; - else + if (vecflag) { + vstore[j] = vstore[i]; + } else if (arrayflag) { for (int m = 0; m < nvalues; m++) astore[j][m] = astore[i][m]; + } else if (tensorflag) { + memcpy(&tstore[j][0][0],&tstore[i][0][0],nbytes); + } } /* ---------------------------------------------------------------------- @@ -249,10 +280,15 @@ int FixStore::pack_exchange(int i, double *buf) { if (disable) return 0; - if (vecflag) buf[0] = vstore[i]; - else + if (vecflag) { + buf[0] = vstore[i]; + } else if (arrayflag) { for (int m = 0; m < nvalues; m++) buf[m] = astore[i][m]; + } else if (tensorflag) { + memcpy(buf,&tstore[i][0][0],nbytes); + } + return nvalues; } @@ -264,10 +300,15 @@ int FixStore::unpack_exchange(int nlocal, double *buf) { if (disable) return 0; - if (vecflag) vstore[nlocal] = buf[0]; - else + if (vecflag) { + vstore[nlocal] = buf[0]; + } else if (arrayflag) { for (int m = 0; m < nvalues; m++) astore[nlocal][m] = buf[m]; + } else if (tensorflag) { + memcpy(&tstore[nlocal][0][0],buf,nbytes); + } + return nvalues; } @@ -284,10 +325,16 @@ int FixStore::pack_restart(int i, double *buf) // pack buf[0] this way because other fixes unpack it buf[0] = nvalues+1; - if (vecflag) buf[1] = vstore[i]; - else + + if (vecflag) { + buf[1] = vstore[i]; + } else if (arrayflag) { for (int m = 0; m < nvalues; m++) buf[m+1] = astore[i][m]; + } else if (tensorflag) { + memcpy(&buf[1],&tstore[i][0][0],nbytes); + } + return nvalues+1; } @@ -308,10 +355,14 @@ void FixStore::unpack_restart(int nlocal, int nth) for (int i = 0; i < nth; i++) m += static_cast (extra[nlocal][m]); m++; - if (vecflag) vstore[nlocal] = extra[nlocal][m]; - else + if (vecflag) { + vstore[nlocal] = extra[nlocal][m]; + } else if (arrayflag) { for (int i = 0; i < nvalues; i++) astore[nlocal][i] = extra[nlocal][m++]; + } else if (tensorflag) { + memcpy(&tstore[nlocal][0][0],&extra[nlocal][m],nbytes); + } } /* ---------------------------------------------------------------------- @@ -335,13 +386,13 @@ int FixStore::size_restart(int /*nlocal*/) } /* ---------------------------------------------------------------------- - memory usage of local atom-based array + memory usage of global or peratom atom-based array ------------------------------------------------------------------------- */ double FixStore::memory_usage() { double bytes = 0.0; - if (flavor == GLOBAL) bytes += (double)nrow*ncol * sizeof(double); - if (flavor == PERATOM) bytes += (double)atom->nmax*nvalues * sizeof(double); + if (flavor == GLOBAL) bytes += n1*n2 * sizeof(double); + if (flavor == PERATOM) bytes += atom->nmax*n2*n3 * sizeof(double); return bytes; } diff --git a/src/fix_store.h b/src/fix_store.h index a30e2d5c1f..16adb174c6 100644 --- a/src/fix_store.h +++ b/src/fix_store.h @@ -26,10 +26,10 @@ namespace LAMMPS_NS { class FixStore : public Fix { public: - int nrow, ncol; // size of global data array - int nvalues; // number of per-atom values + int nrow,ncol; // copy of n1,n2 for GLOBAL array for classes to access double *vstore; // vector storage for GLOBAL or PERATOM double **astore; // array storage for GLOBAL or PERATOM + double ***tstore; // tensor (3d array) storage for PERATOM int disable; // 1 if operations (except grow) are currently disabled FixStore(class LAMMPS *, int, char **); @@ -52,10 +52,16 @@ class FixStore : public Fix { double memory_usage(); private: - int flavor; // GLOBAL or PERATOM - int vecflag; // 1 if ncol=1 or nvalues=1 + int flavor; // GLOBAL or PERATOM + int vecflag; // 1 if ncol=1 or nvalues=1 + int arrayflag; // 1 if a 2d array (vector per atom) + int tensorflag; // 1 if a 3d array (array per atom) - double *rbuf; // restart buffer for GLOBAL vec/array + int n1,n2,n3; // size of 3d dims of data struct + int nvalues; // number of per-atom values + int nbytes; // number of per-atom bytes + + double *rbuf; // restart buffer for GLOBAL vec/array/tensor }; } // namespace LAMMPS_NS diff --git a/src/force.cpp b/src/force.cpp index 0f5d49e9c8..b1cf212f68 100644 --- a/src/force.cpp +++ b/src/force.cpp @@ -47,8 +47,9 @@ Force::Force(LAMMPS *lmp) : Pointers(lmp) special_lj[1] = special_lj[2] = special_lj[3] = 0.0; special_coul[1] = special_coul[2] = special_coul[3] = 0.0; special_angle = special_dihedral = 0; + special_onefive = 0; special_extra = 0; - + dielectric = 1.0; qqr2e_lammps_real = 332.06371; // these constants are toggled qqr2e_charmm_real = 332.0716; // by new CHARMM pair styles @@ -755,7 +756,8 @@ void Force::set_special(int narg, char **arg) special_lj[1] = special_lj[2] = special_lj[3] = 0.0; special_coul[1] = special_coul[2] = special_coul[3] = 0.0; special_angle = special_dihedral = 0; - + special_onefive = 0; + int iarg = 0; while (iarg < narg) { if (strcmp(arg[iarg],"amber") == 0) { @@ -824,6 +826,15 @@ void Force::set_special(int narg, char **arg) else if (strcmp(arg[iarg+1],"yes") == 0) special_dihedral = 1; else error->all(FLERR,"Illegal special_bonds command"); iarg += 2; + } else if (strcmp(arg[iarg],"one/five") == 0) { + if (iarg+2 > narg) error->all(FLERR,"Illegal special_bonds command"); + if (strcmp(arg[iarg+1],"no") == 0) special_onefive = 0; + else if (strcmp(arg[iarg+1],"yes") == 0) special_onefive = 1; + else error->all(FLERR,"Illegal special_bonds command"); + if (special_onefive && atom->nspecial15_flag == 0) + error->all(FLERR,"Cannot set special_bonds one/five if " + "atom style does not support it"); + iarg += 2; } else error->all(FLERR,"Illegal special_bonds command"); } diff --git a/src/force.h b/src/force.h index 09e13c7bd1..54e0938bc7 100644 --- a/src/force.h +++ b/src/force.h @@ -115,7 +115,8 @@ class Force : protected Pointers { int special_dihedral; // 0 if defined dihedrals are ignored // 1 if only weight 1,4 atoms if in a dihedral int special_extra; // extra space for added bonds - + int special_onefive; // 0 if 1-5 neighbors are not stored, 1 if yes + Force(class LAMMPS *); ~Force(); void init(); diff --git a/src/input.cpp b/src/input.cpp index 50e0d45aa0..611a240ffc 100644 --- a/src/input.cpp +++ b/src/input.cpp @@ -1815,6 +1815,7 @@ void Input::special_bonds() double lj3 = force->special_lj[3]; double coul2 = force->special_coul[2]; double coul3 = force->special_coul[3]; + int onefive = force->special_onefive; int angle = force->special_angle; int dihedral = force->special_dihedral; @@ -1825,6 +1826,7 @@ void Input::special_bonds() if (domain->box_exist && atom->molecular == Atom::MOLECULAR) { if (lj2 != force->special_lj[2] || lj3 != force->special_lj[3] || coul2 != force->special_coul[2] || coul3 != force->special_coul[3] || + onefive != force->special_onefive || angle != force->special_angle || dihedral != force->special_dihedral) { Special special(lmp); diff --git a/src/memory.h b/src/memory.h index 5171a4a718..67aadfe26f 100644 --- a/src/memory.h +++ b/src/memory.h @@ -361,10 +361,10 @@ class Memory : protected Pointers { array = nullptr; } - /* ---------------------------------------------------------------------- - create a 3d array with - 1st index from n1lo to n1hi inclusive, - 2nd index from n2lo to n2hi inclusive, +/* ---------------------------------------------------------------------- + create a 3d array with all 3 indices offset + 1st index from n1lo to n1hi inclusive + 2nd index from n2lo to n2hi inclusive 3rd index from n3lo to n3hi inclusive cannot grow it ------------------------------------------------------------------------- */ @@ -512,8 +512,8 @@ class Memory : protected Pointers { array = nullptr; } - /* ---------------------------------------------------------------------- - create a 4d array with indices +/* ---------------------------------------------------------------------- + create a 4d array with indices 2,3,4 offset 2nd index from n2lo to n2hi inclusive 3rd index from n3lo to n3hi inclusive 4th index from n4lo to n4hi inclusive @@ -545,8 +545,8 @@ class Memory : protected Pointers { return nullptr; } - /* ---------------------------------------------------------------------- - free a 4d array with indices 2,3, and 4 offset +/* ---------------------------------------------------------------------- + free a 4d array with indices 2,3,4 offset ------------------------------------------------------------------------- */ template @@ -560,7 +560,55 @@ class Memory : protected Pointers { array = nullptr; } - /* ---------------------------------------------------------------------- +/* ---------------------------------------------------------------------- + create a 4d array with indices 1,2,3 offset + 1st index from n1lo to n2hi inclusive + 2nd index from n3lo to n3hi inclusive + 3rd index from n4lo to n4hi inclusive + cannot grow it +------------------------------------------------------------------------- */ + + template + TYPE ****create4d_offset_last(TYPE ****&array, int n1lo, int n1hi, + int n2lo, int n2hi, int n3lo, int n3hi, int n4, + const char *name) + { + int n1 = n1hi - n1lo + 1; + int n2 = n2hi - n2lo + 1; + int n3 = n3hi - n3lo + 1; + create(array,n1,n2,n3,n4,name); + + bigint m = ((bigint) n1) * n2; + for (bigint i = 0; i < m; i++) array[0][i] -= n3lo; + for (int i = 0; i < n1; i++) array[i] -= n2lo; + array -= n1lo; + return array; + } + + template + TYPE ****create4d_offset_last(TYPE *****& /*array*/, int /*n1lo*/, int /*n1hi*/, + int /*n2lo*/, int /*n2hi*/, + int /*n3lo*/, int /*n3hi*/, int /*n4*/, + const char *name) + {fail(name); return nullptr;} + +/* ---------------------------------------------------------------------- + free a 4d array with indices 1,2,3 offset +------------------------------------------------------------------------- */ + + template + void destroy4d_offset_last(TYPE ****&array, + int n1_offset, int n2_offset, int n3_offset) + { + if (array == nullptr) return; + sfree(&array[n1_offset][n2_offset][n3_offset][0]); + sfree(&array[n1_offset][n2_offset][n3_offset]); + sfree(&array[n1_offset][n2_offset]); + sfree(&array[n1_offset]); + array = nullptr; + } + +/* ---------------------------------------------------------------------- create a 5d array ------------------------------------------------------------------------- */ diff --git a/src/neighbor.cpp b/src/neighbor.cpp index b7217926ca..0ee4051d4b 100644 --- a/src/neighbor.cpp +++ b/src/neighbor.cpp @@ -493,8 +493,8 @@ void Neighbor::init() // flag = 0 if both LJ/Coulomb special values are 0.0 // flag = 1 if both LJ/Coulomb special values are 1.0 // flag = 2 otherwise or if KSpace solver is enabled - // pairwise portion of KSpace solver uses all 1-2,1-3,1-4 neighbors - // or selected Coulomb-approixmation pair styles require it + // b/c pairwise portion of KSpace solver uses all 1-2,1-3,1-4 neighbors + // some Coulomb-approximation pair styles also require it (below) if (force->special_lj[1] == 0.0 && force->special_coul[1] == 0.0) special_flag[1] = 0; @@ -514,10 +514,10 @@ void Neighbor::init() special_flag[3] = 1; else special_flag[3] = 2; - // We cannot remove special neighbors with kspace or kspace-like pair styles - // as the exclusion needs to remove the full coulomb and not the damped interaction. - // Special treatment is required for hybrid pair styles since Force::pair_match() - // will only return a non-null pointer if there is only one substyle of the kind. + // cannot remove special neighbors with kspace or kspace-like pair styles + // b/c exclusion needs to remove the full coulomb and not the damped interaction + // special treatment required for hybrid pair styles since Force::pair_match() + // will only return a non-NULL pointer if there is only one substyle of the kind if (force->kspace) { special_flag[1] = special_flag[2] = special_flag[3] = 2; @@ -526,7 +526,8 @@ void Neighbor::init() if (ph) { int flag=0; for (int isub=0; isub < ph->nstyles; ++isub) { - if (force->pair_match("coul/wolf",0,isub) + if (force->pair_match("amoeba",0,isub) + || force->pair_match("coul/wolf",0,isub) || force->pair_match("coul/dsf",0,isub) || force->pair_match("coul/exclude",0) || force->pair_match("thole",0,isub)) @@ -535,7 +536,8 @@ void Neighbor::init() if (flag) special_flag[1] = special_flag[2] = special_flag[3] = 2; } else { - if (force->pair_match("coul/wolf",0) + if (force->pair_match("amoeba",0) + || force->pair_match("coul/wolf",0) || force->pair_match("coul/dsf",0) || force->pair_match("coul/exclude",0) || force->pair_match("thole",0)) diff --git a/src/pair.h b/src/pair.h index f37c0732ed..5f3230f23b 100644 --- a/src/pair.h +++ b/src/pair.h @@ -190,6 +190,12 @@ class Pair : protected Pointers { virtual void unpack_forward_comm(int, int, double *) {} virtual int pack_reverse_comm(int, int, double *) { return 0; } virtual void unpack_reverse_comm(int, int *, double *) {} + + virtual void pack_forward_grid(int, void *, int, int *) {} + virtual void unpack_forward_grid(int, void *, int, int *) {} + virtual void pack_reverse_grid(int, void *, int, int *) {} + virtual void unpack_reverse_grid(int, void *, int, int *) {} + virtual double memory_usage(); void set_copymode(int value) { copymode = value; } diff --git a/src/special.cpp b/src/special.cpp index dcc0d0c0ad..316979377d 100644 --- a/src/special.cpp +++ b/src/special.cpp @@ -35,7 +35,7 @@ Special::Special(LAMMPS *lmp) : Pointers(lmp) MPI_Comm_rank(world,&me); MPI_Comm_size(world,&nprocs); - onetwo = onethree = onefour = nullptr; + onetwo = onethree = onefour = onefive = NULL; } /* ---------------------------------------------------------------------- */ @@ -45,12 +45,13 @@ Special::~Special() memory->destroy(onetwo); memory->destroy(onethree); memory->destroy(onefour); + memory->destroy(onefive); } /* ---------------------------------------------------------------------- - create 1-2, 1-3, 1-4 lists of topology neighbors - store in onetwo, onethree, onefour for each atom - store 3 counters in nspecial[i] + create 1-2, 1-3, 1-4 lists of topology neighbors, 1-5 list is optional + store in onetwo, onethree, onefour, onefive for each atom + store first 3 counters in nspecial[i], and 4th in nspecial15[i] ------------------------------------------------------------------------- */ void Special::build() @@ -69,9 +70,14 @@ void Special::build() utils::logmesg(lmp,mesg); } + // set onefive_flag if special_bonds command set it + + onefive_flag = force->special_onefive; + // initialize nspecial counters to 0 int **nspecial = atom->nspecial; + int *nspecial15 = atom->nspecial15; int nlocal = atom->nlocal; for (int i = 0; i < nlocal; i++) { @@ -80,6 +86,10 @@ void Special::build() nspecial[i][2] = 0; } + if (onefive_flag) { + for (int i = 0; i < nlocal; i++) nspecial15[i] = 0; + } + // setup atomIDs and procowner vectors in rendezvous decomposition atom_owners(); @@ -96,8 +106,10 @@ void Special::build() utils::logmesg(lmp,"{:>6} = max # of 1-2 neighbors\n",maxall); // done if special_bond weights for 1-3, 1-4 are set to 1.0 - - if (force->special_lj[2] == 1.0 && force->special_coul[2] == 1.0 && + // onefive_flag must also be off, else 1-4 is needed to create 1-5 + + if (!onefive_flag && + force->special_lj[2] == 1.0 && force->special_coul[2] == 1.0 && force->special_lj[3] == 1.0 && force->special_coul[3] == 1.0) { dedup(); combine(); @@ -119,8 +131,10 @@ void Special::build() utils::logmesg(lmp,"{:>6} = max # of 1-3 neighbors\n",maxall); // done if special_bond weights for 1-4 are set to 1.0 - - if (force->special_lj[3] == 1.0 && force->special_coul[3] == 1.0) { + // onefive_flag must also be off, else 1-4 is needed to create 1-5 + + if (!onefive_flag && + force->special_lj[3] == 1.0 && force->special_coul[3] == 1.0) { dedup(); if (force->special_angle) angle_trim(); combine(); @@ -141,7 +155,17 @@ void Special::build() if (me == 0) utils::logmesg(lmp,"{:>6} = max # of 1-4 neighbors\n",maxall); - // finish processing the onetwo, onethree, onefour lists + // optionally store 1-5 neighbors + // tally nspecial15[i] = # of 1-5 neighbors of atom i + // create onefive[i] = list of 1-5 neighbors for atom i + + if (onefive_flag) { + onefive_build(); + if (me == 0) + utils::logmesg(lmp,fmt::format("{:>6} = max # of 1-5 neighbors\n",maxall)); + } + + // finish processing the onetwo, onethree, onefour, onefive lists dedup(); if (force->special_angle) angle_trim(); @@ -150,7 +174,6 @@ void Special::build() fix_alteration(); memory->destroy(procowner); memory->destroy(atomIDs); - timer_output(time1); } @@ -450,7 +473,7 @@ void Special::onefour_build() // setup input buf to rendezvous comm // datums = pairs of onethree and onetwo partners where onethree is unknown // these pairs are onefour neighbors - // datum = onetwo ID, onetwo ID + // datum = onethree ID, onetwo ID // owning proc for each datum = onethree ID % nprocs nsend = 0; @@ -521,8 +544,113 @@ void Special::onefour_build() memory->sfree(outbuf); } +/* ---------------------------------------------------------------------- + optional onefive build + uses rendezvous comm +------------------------------------------------------------------------- */ + +void Special::onefive_build() +{ + int i,j,k,m,proc; + + int **nspecial = atom->nspecial; + int *nspecial15 = atom->nspecial15; + int nlocal = atom->nlocal; + + // nsend = # of my datums to send + + int nsend = 0; + for (i = 0; i < nlocal; i++) { + for (j = 0; j < nspecial[i][2]; j++) { + m = atom->map(onefour[i][j]); + if (m < 0 || m >= nlocal) nsend += nspecial[i][0]; + } + } + + int *proclist; + memory->create(proclist,nsend,"special:proclist"); + PairRvous *inbuf = (PairRvous *) + memory->smalloc((bigint) nsend*sizeof(PairRvous),"special:inbuf"); + + // setup input buf to rendezvous comm + // datums = pairs of onefour and onetwo partners where onefour is unknown + // these pairs are onefive neighbors + // datum = onefour ID, onetwo ID + // owning proc for each datum = onefour ID % nprocs + + nsend = 0; + for (i = 0; i < nlocal; i++) { + for (j = 0; j < nspecial[i][2]; j++) { + m = atom->map(onefour[i][j]); + if (m >= 0 && m < nlocal) continue; + proc = onefour[i][j] % nprocs; + for (k = 0; k < nspecial[i][0]; k++) { + proclist[nsend] = proc; + inbuf[nsend].atomID = onefour[i][j]; + inbuf[nsend].partnerID = onetwo[i][k]; + nsend++; + } + } + } + + // perform rendezvous operation + + char *buf; + int nreturn = comm->rendezvous(RVOUS,nsend,(char *) inbuf,sizeof(PairRvous), + 0,proclist, + rendezvous_pairs,0,buf,sizeof(PairRvous), + (void *) this); + PairRvous *outbuf = (PairRvous *) buf; + + memory->destroy(proclist); + memory->sfree(inbuf); + + // set nspecial15 and onefive for all owned atoms + // based on owned info plus rendezvous output info + // output datums = pairs of atoms that are 1-5 neighbors + + for (i = 0; i < nlocal; i++) { + for (j = 0; j < nspecial[i][2]; j++) { + m = atom->map(onefour[i][j]); + if (m >= 0 && m < nlocal) nspecial15[m] += nspecial[i][0]; + } + } + + for (m = 0; m < nreturn; m++) { + i = atom->map(outbuf[m].atomID); + nspecial15[i]++; + } + + int max = 0; + for (i = 0; i < nlocal; i++) + max = MAX(max,nspecial15[i]); + + MPI_Allreduce(&max,&maxall,1,MPI_INT,MPI_MAX,world); + memory->create(onefive,nlocal,maxall,"special:onefive"); + + for (i = 0; i < nlocal; i++) nspecial15[i] = 0; + + for (i = 0; i < nlocal; i++) { + for (j = 0; j < nspecial[i][2]; j++) { + m = atom->map(onefour[i][j]); + if (m < 0 || m >= nlocal) continue; + for (k = 0; k < nspecial[i][0]; k++) { + onefive[m][nspecial15[m]++] = onetwo[i][k]; + } + } + } + + for (m = 0; m < nreturn; m++) { + i = atom->map(outbuf[m].atomID); + onefive[i][nspecial15[i]++] = outbuf[m].partnerID; + } + + memory->sfree(outbuf); +} + /* ---------------------------------------------------------------------- remove duplicates within each of onetwo, onethree, onefour individually + also dedup onefive if enabled ------------------------------------------------------------------------- */ void Special::dedup() @@ -536,15 +664,18 @@ void Special::dedup() // use map to cull duplicates // exclude original atom explicitly - // adjust onetwo, onethree, onefour values to reflect removed duplicates + // adjust onetwo, onethree, onefour, onefive values to remove duplicates // must unset map for each atom int **nspecial = atom->nspecial; + int *nspecial15 = atom->nspecial15; tagint *tag = atom->tag; int nlocal = atom->nlocal; int unique; + // dedup onetwo + for (i = 0; i < nlocal; i++) { unique = 0; atom->map_one(tag[i],0); @@ -560,6 +691,8 @@ void Special::dedup() for (j = 0; j < unique; j++) atom->map_one(onetwo[i][j],-1); } + // dedup onethree + for (i = 0; i < nlocal; i++) { unique = 0; atom->map_one(tag[i],0); @@ -574,6 +707,8 @@ void Special::dedup() atom->map_one(tag[i],-1); for (j = 0; j < unique; j++) atom->map_one(onethree[i][j],-1); } + + // dedup onefour for (i = 0; i < nlocal; i++) { unique = 0; @@ -590,6 +725,25 @@ void Special::dedup() for (j = 0; j < unique; j++) atom->map_one(onefour[i][j],-1); } + // dedup onefive + + if (onefive_flag) { + for (i = 0; i < nlocal; i++) { + unique = 0; + atom->map_one(tag[i],0); + for (j = 0; j < nspecial15[i]; j++) { + m = onefive[i][j]; + if (atom->map(m) < 0) { + onefive[i][unique++] = m; + atom->map_one(m,0); + } + } + nspecial15[i] = unique; + atom->map_one(tag[i],-1); + for (j = 0; j < unique; j++) atom->map_one(onefive[i][j],-1); + } + } + // re-create map atom->map_init(0); @@ -601,6 +755,7 @@ void Special::dedup() concatenate onetwo, onethree, onefour into master atom->special list remove duplicates between 3 lists, leave dup in first list it appears in convert nspecial[0], nspecial[1], nspecial[2] into cumulative counters + if 1-5 is enabled, reset nspecial15/special15 to remove dups with 1-2,1-3,1-4 ------------------------------------------------------------------------- */ void Special::combine() @@ -612,6 +767,7 @@ void Special::combine() MPI_Comm_rank(world,&me); int **nspecial = atom->nspecial; + int *nspecial15 = atom->nspecial15; tagint *tag = atom->tag; int nlocal = atom->nlocal; @@ -624,13 +780,15 @@ void Special::combine() atom->map_clear(); // unique = # of unique nspecial neighbors of one atom + // unique15 = ditto for 1-5 interactions // cull duplicates using map to check for them // exclude original atom explicitly // must unset map for each atom - int unique; + int unique,unique15; int maxspecial = 0; - + int maxspecial15 = 0; + for (i = 0; i < nlocal; i++) { unique = 0; atom->map_one(tag[i],0); @@ -659,15 +817,30 @@ void Special::combine() maxspecial = MAX(maxspecial,unique); + if (onefive_flag) { + unique15 = 0; + for (j = 0; j < nspecial15[i]; j++) { + m = onefive[i][j]; + if (atom->map(m) < 0) { + unique15++; + atom->map_one(m,0); + } + } + maxspecial15 = MAX(maxspecial15,unique15); + } + atom->map_one(tag[i],-1); for (j = 0; j < nspecial[i][0]; j++) atom->map_one(onetwo[i][j],-1); for (j = 0; j < nspecial[i][1]; j++) atom->map_one(onethree[i][j],-1); for (j = 0; j < nspecial[i][2]; j++) atom->map_one(onefour[i][j],-1); + if (onefive_flag) + for (j = 0; j < nspecial15[i]; j++) atom->map_one(onefive[i][j],-1); } - // if atom->maxspecial has been updated before, make certain - // we do not reset it to a smaller value. Since atom->maxspecial - // is initialized to 1, this ensures that it is larger than zero. + // if atom->maxspecial has been updated before, + // make certain it is not reset to a smaller value + // since atom->maxspecial is initialized to 1, + // this ensures that it stays larger than zero maxspecial = MAX(atom->maxspecial,maxspecial); @@ -702,12 +875,23 @@ void Special::combine() memory->create(atom->special,atom->nmax,atom->maxspecial,"atom:special"); } - tagint **special = atom->special; + // if 1-5 is enabled, similarly compute global maxspecial15 and reallocate + + if (onefive_flag) { + maxspecial15 = MAX(atom->maxspecial15,maxspecial15); + MPI_Allreduce(&maxspecial15,&atom->maxspecial15,1,MPI_INT,MPI_MAX,world); + memory->destroy(atom->special15); + memory->create(atom->special15,atom->nmax,atom->maxspecial15,"atom:special15"); + } // ---------------------------------------------------- // fill special array with 1-2, 1-3, 1-4 neighs for each atom + // optionally fill special15 array with 1-5 neighs // ---------------------------------------------------- + tagint **special = atom->special; + tagint **special15 = atom->special15; + // again use map to cull duplicates // exclude original atom explicitly // adjust nspecial[i] values to reflect removed duplicates @@ -744,8 +928,22 @@ void Special::combine() } nspecial[i][2] = unique; + if (onefive_flag) { + unique15 = 0; + for (j = 0; j < nspecial15[i]; j++) { + m = onefive[i][j]; + if (atom->map(m) < 0) { + special15[i][unique15++] = m; + atom->map_one(m,0); + } + } + nspecial15[i] = unique15; + } + atom->map_one(tag[i],-1); for (j = 0; j < nspecial[i][2]; j++) atom->map_one(special[i][j],-1); + if (onefive_flag) + for (j = 0; j < nspecial15[i]; j++) atom->map_one(special15[i][j],-1); } // re-create map diff --git a/src/special.h b/src/special.h index 8fb39ea563..db78d71aa1 100644 --- a/src/special.h +++ b/src/special.h @@ -27,7 +27,8 @@ class Special : protected Pointers { private: int me, nprocs; int maxall; - tagint **onetwo, **onethree, **onefour; + int onefive_flag; + tagint **onetwo,**onethree,**onefour,**onefive; // data used by rendezvous callback methods @@ -51,6 +52,7 @@ class Special : protected Pointers { void onetwo_build_newton_off(); void onethree_build(); void onefour_build(); + void onefive_build(); void dedup(); void angle_trim(); diff --git a/tools/README b/tools/README index eb329e27cd..ce301aef67 100644 --- a/tools/README +++ b/tools/README @@ -48,6 +48,7 @@ singularity Singularity container descriptions suitable for LAMMPS de smd convert Smooth Mach Dynamics triangles to VTK spin perform a cubic polynomial interpolation of a GNEB MEP swig Interface file and demo scripts for SWIG wrappers for the LAMMPS C library interface +tinker2lmp.py convert Tinker input files to LAMMPS input files valgrind suppression files for use with valgrind's memcheck tool vim add-ons to VIM editor for editing LAMMPS input scripts xmgrace a collection of scripts to generate xmgrace plots diff --git a/tools/tinker2lmp.py b/tools/tinker2lmp.py new file mode 100644 index 0000000000..3f5bb90f8a --- /dev/null +++ b/tools/tinker2lmp.py @@ -0,0 +1,913 @@ +#!/bin/env python + +# convert a Tinker XYZ file + PRM file to a LAMMPS data file + +# Syntax: python tinker2lmp.py -switch args -switch args ... +# -xyz file = Tinker XYZ file name (required) +# -amoeba file = AMOEBA PRM force field file name (required, or hippo) +# -hippo file = HIPPO PRM force field file name (required, or amoeba) +# -data file = LAMMPS data file to output (required) +# -nopbc = non-periodic system (default) +# -pbc xhi yhi zhi = periodic system from 0 to hi in each dimension (optional) + +import sys,os,math +path = os.environ["LAMMPS_PYTHON_TOOLS"] +sys.path.append(path) +from data import data + +BIG = 1.0e20 +DELTA = 0.001 # delta on LAMMPS shrink-wrap box size, in Angstroms + +# ---------------------- +# methods and classes +# ---------------------- + +# print an error message and exit + +def error(txt=""): + if not txt: + print "Syntax: tinker2lmp.py -switch args ..." + print " -xyz file" + print " -amoeba file" + print " -hippo file" + print " -data file" + print " -nopbc" + print " -pbc xhi yhi zhi" + else: print "ERROR:",txt + sys.exit() + +# read and store values from a Tinker xyz file + +class XYZfile: + def __init__(self,file): + lines = open(file,'r').readlines() + natoms = int(lines[0].split()[0]) + id = [] + type = [] + x = [] + y = [] + z = [] + bonds = [] + + for line in lines[1:natoms+1]: + words = line.split() + id.append(int(words[0])) + x.append(words[2]) + y.append(words[3]) + z.append(words[4]) + type.append(int(words[5])) + blist = words[6:] + blist = [int(one) for one in blist] + bonds.append(blist) + + self.natoms = natoms + self.id = id + self.type = type + self.x = x + self.y = y + self.z = z + self.bonds = bonds + + # triplet of atoms in an angle = atom 1,2,3 + # atom2 is center atom + # nbonds = number of atoms which atom2 is bonded to + # hcount = # of H atoms which atom2 is bonded to, excluding atom1 and atom3 + + def angle_hbond_count(self,atom1,atom2,atom3,lmptype,lmpmass): + bondlist = self.bonds[atom2-1] + nbonds = len(bondlist) + + hcount = 0 + for bondID in bondlist: + if atom1 == bondID: continue + if atom3 == bondID: continue + massone = lmpmass[lmptype[bondID-1]-1] + if int(massone+0.5) == 1: hcount += 1 + + return nbonds,hcount + +# read and store select values from a Tinker force field PRM file +# ntypes = # of Tinker types +# per-type values: class and mass +# scalar force field params in Force Field Definition section +# bond, angle, dihedral coeffs indexed by Tinker classes + +class PRMfile: + def __init__(self,file): + lines = open(file,'r').readlines() + self.nlines = len(lines) + self.lines = lines + + self.force_field_definition() + self.classes,self.masses = self.peratom() + self.polgroup = self.polarize() + self.bondparams = self.bonds() + self.angleparams = self.angles() + self.bondangleparams = self.bondangles() + self.torsionparams = self.torsions() + self.ntypes = len(self.masses) + + def force_field_definition(self): + iline = self.find_section("Force Field Definition") + iline += 3 + while iline < self.nlines: + words = self.lines[iline].split() + if len(words): + if words[0].startswith("###########"): break + if words[0] == "bond-cubic": self.bond_cubic = float(words[1]) + elif words[0] == "bond-quartic": self.bond_quartic = float(words[1]) + elif words[0] == "angle-cubic": self.angle_cubic = float(words[1]) + elif words[0] == "angle-quartic": self.angle_quartic = float(words[1]) + elif words[0] == "angle-pentic": self.angle_pentic = float(words[1]) + elif words[0] == "angle-sextic": self.angle_sextic = float(words[1]) + iline += 1 + + def peratom(self): + classes = [] + masses = [] + iline = self.find_section("Atom Type Definitions") + if iline < 0: return classes,masses + iline += 3 + while iline < self.nlines: + words = self.lines[iline].split() + if len(words): + if words[0].startswith("###########"): break + # NOTE: assumes atom entries are numbered consecutively + if words[0] == "atom": + classes.append(int(words[2])) + masses.append(float(words[-2])) + iline += 1 + return classes,masses + + def polarize(self): + polgroup = [] + iline = self.find_section("Dipole Polarizability Parameters") + if iline < 0: return polgroup + iline += 3 + while iline < self.nlines: + words = self.lines[iline].split() + if len(words): + if words[0].startswith("###########"): break + # trim off any end-of-line comments + if "!!" in words: words = words[:words.index("!!")] + # NOTE: assumes polarize entries are numbered consecutively + if words[0] == "polarize": + if amoeba: bondtypes = words[4:] + if hippo: bondtypes = words[3:] + bondtypes = [int(one) for one in bondtypes] + polgroup.append(bondtypes) + iline += 1 + return polgroup + + # convert PRMfile params to LAMMPS bond_style class2 params + + def bonds(self): + params = [] + iline = self.find_section("Bond Stretching Parameters") + if iline < 0: return params + iline += 3 + while iline < self.nlines: + words = self.lines[iline].split() + if len(words): + if words[0].startswith("###########"): break + if words[0] == "bond": + class1 = int(words[1]) + class2 = int(words[2]) + value1 = float(words[3]) + value2 = float(words[4]) + lmp1 = value2 + lmp2 = value1 + lmp3 = self.bond_cubic * value1 + lmp4 = self.bond_quartic * value1 + params.append((class1,class2,lmp1,lmp2,lmp3,lmp4)) + iline += 1 + return params + + # convert PRMfile params to LAMMPS angle_style class2/p6 params + # line may have prefactor plus 1,2,3 angle0 params + # save prefactor/angle0 pairs as option 1,2,3 + + def angles(self): + r2d = 180.0 / math.pi + params = [] + iline = self.find_section("Angle Bending Parameters") + if iline < 0: return params + iline += 3 + while iline < self.nlines: + words = self.lines[iline].split() + if len(words): + if words[0].startswith("###########"): break + if words[0] == "angle" or words[0] == "anglep": + if words[0] == "angle": pflag = 0 + if words[0] == "anglep": pflag = 1 + + class1 = int(words[1]) + class2 = int(words[2]) + class3 = int(words[3]) + value1 = float(words[4]) + value2 = float(words[5]) + option1 = () + option2 = () + option3 = () + + lmp1 = value2 + lmp2 = value1 + lmp3 = self.angle_cubic * value1 * r2d + lmp4 = self.angle_quartic * value1 * r2d*r2d + lmp5 = self.angle_pentic * value1 * r2d*r2d*r2d + lmp6 = self.angle_sextic * value1 * r2d*r2d*r2d*r2d + + option1 = (pflag,lmp1,lmp2,lmp3,lmp4,lmp5,lmp6) + + if len(words) >= 7: + value3 = float(words[6]) + lmp1 = value3 + option2 = (pflag,lmp1,lmp2,lmp3,lmp4,lmp5,lmp6) + + if len(words) == 8: + value4 = float(words[7]) + lmp1 = value4 + option3 = (pflag,lmp1,lmp2,lmp3,lmp4,lmp5,lmp6) + + if not option2 and not option3: + params.append((class1,class2,class3,[option1])) + elif not option3: + params.append((class1,class2,class3,[option1,option2])) + else: + params.append((class1,class2,class3,[option1,option2,option3])) + + iline += 1 + return params + + # convert PRMfile params to LAMMPS angle_style class2/p6 bondangle params + # lmp3,lmp4 = equilibrium bond lengths for 2 bonds in angle + # need to find these values in self.bondparams + # put them in a dictionary for efficient searching + + def bondangles(self): + params = [] + iline = self.find_section("Stretch Bend Parameters") + if iline < 0: return params + iline += 3 + + bdict = {} + for m,params in enumerate(self.bondparams): + bdict[(params[0],params[1])] = params[2] + + while iline < self.nlines: + words = self.lines[iline].split() + if len(words): + if words[0].startswith("###########"): break + if words[0] == "strbnd": + class1 = int(words[1]) + class2 = int(words[2]) + class3 = int(words[3]) + value1 = float(words[4]) + value2 = float(words[5]) + lmp1 = value1 + lmp2 = value2 + lmp3 = lmp4 = 0.0 + if (class2,class1) in bdict: lmp3 = bdict[(class2,class1)] + if (class1,class2) in bdict: lmp3 = bdict[(class1,class2)] + if (class2,class3) in bdict: lmp4 = bdict[(class2,class3)] + if (class3,class2) in bdict: lmp4 = bdict[(class3,class2)] + if lmp3 == 0.0 or lmp4 == 0.0: + print "Bond in BondAngle term not found",class1,class2,class3 + sys.exit() + params.append((class1,class2,class3,lmp1,lmp2,lmp3,lmp4)) + iline += 1 + return params + + def torsions(self): + params = [] + iline = self.find_section("Torsional Parameters") + if iline < 0: return params + iline += 3 + while iline < self.nlines: + words = self.lines[iline].split() + if len(words): + if words[0].startswith("###########"): break + if words[0] == "torsion": + class1 = int(words[1]) + class2 = int(words[2]) + class3 = int(words[3]) + class4 = int(words[4]) + value1 = words[5] + value2 = words[6] + value3 = words[7] + value4 = words[8] + value5 = words[9] + value6 = words[10] + value7 = words[11] + value8 = words[12] + value9 = words[13] + params.append((class1,class2,class3,class4, + value1,value2,value3,value4,value5, + value6,value7,value8,value9)) + iline += 1 + return params + + def find_section(self,txt): + txt = "## %s ##" % txt + for iline,line in enumerate(self.lines): + if txt in line: return iline + return -1 + +# ---------------------------------------- +# main program +# ---------------------------------------- + +args = sys.argv[1:] +narg = len(args) + +# process args + +amoeba = hippo = 0 +xyzfile = "" +prmfile = "" +datafile = "" +pbcflag = 0 + +iarg = 0 +while iarg < narg: + if args[iarg] == "-xyz": + if iarg + 2 > narg: error() + xyzfile = args[iarg+1] + iarg += 2 + elif args[iarg] == "-amoeba": + if iarg + 2 > narg: error() + amoeba = 1 + prmfile = args[iarg+1] + iarg += 2 + elif args[iarg] == "-hippo": + if iarg + 2 > narg: error() + hippo = 1 + prmfile = args[iarg+1] + iarg += 2 + elif args[iarg] == "-data": + if iarg + 2 > narg: error() + datafile = args[iarg+1] + iarg += 2 + elif args[iarg] == "-nopbc": + pbcflag = 0 + iarg += 1 + elif args[iarg] == "-pbc": + if iarg + 4 > narg: error() + pbcflag = 1 + xhi = float(args[iarg+1]) + yhi = float(args[iarg+2]) + zhi = float(args[iarg+3]) + boxhi = [xhi,yhi,zhi] + iarg += 4 + else: error() + +# error check + +if not xyzfile: error("xyzfile not specified") +if not prmfile: error("prmfile not specified") +if not datafile: error("datafile not specified") + +# read Tinker xyz and prm files + +xyz = XYZfile(xyzfile) +prm = PRMfile(prmfile) + +# create LAMMPS box bounds based on pbcflag + +natoms = xyz.natoms +x = xyz.x +y = xyz.y +z = xyz.z + +if pbcflag: + boxlo = [0,0,0] +else: + xlo = ylo = zlo = BIG + xhi = yhi = zhi = -BIG + for i in xrange(natoms): + xlo = min(xlo,float(x[i])) + ylo = min(ylo,float(y[i])) + zlo = min(zlo,float(z[i])) + xhi = max(xhi,float(x[i])) + yhi = max(yhi,float(y[i])) + zhi = max(zhi,float(z[i])) + boxlo = [xlo-DELTA,ylo-DELTA,zlo-DELTA] + boxhi = [xhi+DELTA,yhi+DELTA,zhi+DELTA] + +# ---------------------------------------- +# create LAMMPS atom types for each unique Tinker per-type mass +# NOTE: maybe should assign LAMMPS types in a different way, +# e.g. one LAMMPS type for each used Tinker type +# ---------------------------------------- + +# ntypes = # of LAMMPS atoms types = unique Tinker masses +# lmptype = which LAMMPS type for each atom (1 to Ntypes) +# lmpmass = list of per-type masses +# ttype = list of Tinker types for each atom (1 to prm.ntypes) +# tink2lmp = mapping of Tinker types to LAMMPS types + +natoms = xyz.natoms +ttype = xyz.type +tmasses = prm.masses + +ntypes = 0 +lmptype = [] +lmpmass = [] +tink2lmp = {} + +for itype in ttype: + if itype not in tink2lmp: + mass = tmasses[itype-1] + if mass not in lmpmass: + ntypes += 1 + lmpmass.append(mass) + jtype = ntypes + else: jtype = lmpmass.index(mass) + 1 + tink2lmp[itype] = jtype + lmptype.append(tink2lmp[itype]) + +# ---------------------------------------- +# identify molecules from Tinker bond connectivity +# ---------------------------------------- + +# molID = which molecule each atom is in (1 to Nmol) +# use stack to store IDs of atoms to recursively loop over + +natoms = xyz.natoms +id = xyz.id +bonds = xyz.bonds + +molID = natoms*[0] +nmol = 0 + +for i in id: + if molID[i-1] > 0: continue + nmol += 1 + molID[i-1] = nmol + stack = [i] + while stack: + j = stack.pop() + for k in bonds[j-1]: + if molID[k-1] == 0: + molID[k-1] = nmol + stack.append(k) + +# ---------------------------------------- +# create lists of bonds, angles, dihedrals +# ---------------------------------------- + +# create blist = list of bonds +# avoid double counting by requiring atom1 < atom2 + +id = xyz.id +type = xyz.type +bonds = xyz.bonds + +blist = [] + +for atom1 in id: + for atom2 in bonds[atom1-1]: + if atom1 < atom2: + blist.append((atom1,atom2)) + +# create alist = list of angles +# generate topology by double loop over bonds of center atom2 +# avoid double counting by requiring atom1 < atom3 + +id = xyz.id +type = xyz.type +bonds = xyz.bonds + +alist = [] + +for atom2 in id: + for atom1 in bonds[atom2-1]: + for atom3 in bonds[atom2-1]: + if atom3 == atom1: continue + if atom1 < atom3: + alist.append((atom1,atom2,atom3)) + +# create dlist = list of dihedrals +# generate topology via triple loop over neighbors of dihedral atom2 +# double loop over bonds of atom2 +# additional loop over bonds of atom3 +# avoid double counting by requiring atom1 < atom3 + +id = xyz.id +type = xyz.type +bonds = xyz.bonds + +dlist = [] + +for atom2 in id: + for atom1 in bonds[atom2-1]: + for atom3 in bonds[atom2-1]: + if atom3 == atom1: continue + for atom4 in bonds[atom3-1]: + if atom4 == atom2 or atom4 == atom1: continue + if atom1 < atom3: + dlist.append((atom1,atom2,atom3,atom4)) + +# ---------------------------------------- +# create lists of bond/angle/dihedral types +# ---------------------------------------- + +# generate btype = LAMMPS type of each bond +# generate bparams = LAMMPS params for each bond type +# flags[i] = which LAMMPS bond type (1-N) the Ith Tinker PRM file bond is +# 0 = none +# convert prm.bondparams to a dictionary for efficient searching +# key = (class1,class2) +# value = (M,params) where M is index into prm.bondparams + +id = xyz.id +type = xyz.type +classes = prm.classes + +bdict = {} +for m,params in enumerate(prm.bondparams): + bdict[(params[0],params[1])] = (m,params) + +flags = len(prm.bondparams)*[0] +btype = [] +bparams = [] + +for atom1,atom2 in blist: + type1 = type[atom1-1] + type2 = type[atom2-1] + c1 = classes[type1-1] + c2 = classes[type2-1] + + if (c1,c2) in bdict: m,params = bdict[(c1,c2)] + elif (c2,c1) in bdict: m,params = bdict[(c2,c1)] + else: + print "Bond not found",atom1,atom2,c1,c2 + sys.exit() + + if not flags[m]: + v1,v2,v3,v4 = params[2:] + bparams.append((v1,v2,v3,v4)) + flags[m] = len(bparams) + btype.append(flags[m]) + +# generate atype = LAMMPS type of each angle +# generate aparams = LAMMPS params for each angle type +# generate baparams = LAMMPS bond-angle params for each angle type +# flags[i] = which LAMMPS angle type (1-N) the Tinker FF file angle I is +# 0 = none +# Tinker FF file angle entries can have 1, 2, or 3 options +# noptions = total # of Tinker FF file entries with options included +# convert prm.angleparams to a dictionary for efficient searching +# key = (class1,class2) +# value = (M,params) where M is index into prm.angleparams + +id = xyz.id +type = xyz.type +classes = prm.classes + +adict = {} +noptions = 0 +for m,params in enumerate(prm.angleparams): + adict[(params[0],params[1],params[2])] = (noptions,params) + n = len(params[3]) + noptions += n + +flags = noptions*[0] +#baflags = len(baprm)*[0] +atype = [] +aparams = [] +baparams = [] + +#DEBUG +opcount = 0 + +for atom1,atom2,atom3 in alist: + type1 = type[atom1-1] + type2 = type[atom2-1] + type3 = type[atom3-1] + c1 = classes[type1-1] + c2 = classes[type2-1] + c3 = classes[type3-1] + + if (c1,c2,c3) in adict or (c3,c2,c1) in adict: + if (c1,c2,c3) in adict: m,params = adict[(c1,c2,c3)] + if (c3,c2,c1) in adict: m,params = adict[(c3,c2,c1)] + + # params is a sequence of 1 or 2 or 3 options + # which = which of 1,2,3 options this atom triplet matches + # for which = 2 or 3, increment m to index correct position in flags + # how match is determined: + # if 2 options: + # require atom2 have 3 bond partners, including atom1 and atom3 + # option 1 if additional bond is not to an H atom + # option 2 if additional bond is to an H atom + # if 3 options: + # require atom2 have 4 bond partners, including atom1 and atom3 + # option 1 if neither of 2 additional bonds is to an H atom + # option 2 if one of 2 additional bonds is to an H atom + # option 3 if both of 2 additional bonds is to an H atom + + # DEBUG + debugflag = 0 + + if len(params[3]) == 1: + which = 1 + + elif len(params[3]) == 2: + nbonds,hcount = xyz.angle_hbond_count(atom1,atom2,atom3,lmptype,lmpmass) + + if nbonds != 3: + print "Center angle atom has wrong bond count" + print " angle atom IDs:",atom1,atom2,atom3 + print " angle atom classes:",c1,c2,c3 + print " Tinker FF file param options:",len(params[3]) + print " Nbonds and hydrogen count:",nbonds,hcount + #sys.exit() // NOTE: allow this for now + + if hcount == 0: which = 1 + elif hcount == 1: + which = 2 + m += 1 + + print "3-bond angle" + print " angle atom IDs:",atom1,atom2,atom3 + print " angle atom classes:",c1,c2,c3 + print " Tinker FF file param options:",len(params[3]) + print " Nbonds and hydrogen count:",nbonds,hcount + print " which:",which,m + + # DEBUG + debugflag = 1 + opcount += 1 + + elif len(params[3]) == 3: + nbonds,hcount = xyz.angle_hbond_count(atom1,atom2,atom3,lmptype,lmpmass) + + if nbonds != 4: + print "Center angle atom has wrong bond count" + print " angle atom IDs:",atom1,atom2,atom3 + print " angle atom classes:",c1,c2,c3 + print " Tinker FF file param options:",len(params[3]) + print " Nbonds and hydrogen count:",nbonds,hcount + #sys.exit() // NOTE: allow this for now + + if hcount == 0: which = 1 + elif hcount == 1: + which = 2 + m += 1 + elif hcount == 2: + which = 3 + m += 2 + + print "4-bond angle" + print " angle atom IDs:",atom1,atom2,atom3 + print " angle atom classes:",c1,c2,c3 + print " Tinker FF file param options:",len(params[3]) + print " Nbonds and hydrogen count:",nbonds,hcount + print " which:",which,m + + # DEBUG + debugflag = 1 + opcount += 1 + + else: + print "Angle not found",atom1,atom2,atom3,c1,c2,c3 + sys.exit() + + if not flags[m]: + pflag,v1,v2,v3,v4,v5,v6 = params[3][which-1] + # DEBUG single line + if debugflag: pflag = 2 + aparams.append((pflag,v1,v2,v3,v4,v5,v6)) + flags[m] = len(aparams) + atype.append(flags[m]) + +print "OPTION angles",opcount + + # NOTE: baparams may need to be flipped if match is 3,2,1 instead of 1,2,3 + + # NOTE: mismatch between angle and bondangle params may not be handled right + # should be a new LAMMPS type if either angle or bondangle params do not match? + #for m,params in enumerate(baprm): + # c1,c2,c3,v1,v2,v3,v4 = params + # if (c1 == class1 and c2 == class2 and c3 == class3) or \ + # (c1 == class3 and c2 == class2 and c3 == class1): + # found += 1 + # if baflags[m]: + # continue + # #atype.append(baflags[m]) + # else: + # baparams.append((v1,v2,v3,v4)) + # baflags[m] = len(baparams) + # #atype.append(baflags[m]) + # break + # if found != 1: print "Not found",atom1,atom2,atom3,class1,class2,class3 + +# generate dtype = LAMMPS type of each dihedral +# generate dparams = LAMMPS params for each dihedral type +# flags[i] = which LAMMPS dihedral type (1-N) the Tinker FF file dihedral I is +# 0 = none +# convert prm.torsionparams to a dictionary for efficient searching +# key = (class1,class2) +# value = (M,params) where M is index into prm.torsionparams + +id = xyz.id +type = xyz.type +classes = prm.classes + +ddict = {} +for m,params in enumerate(prm.torsionparams): + ddict[(params[0],params[1],params[2],params[3])] = (m,params) + +flags = len(prm.torsionparams)*[0] +dtype = [] +dparams = [] + +for atom1,atom2,atom3,atom4 in dlist: + type1 = type[atom1-1] + type2 = type[atom2-1] + type3 = type[atom3-1] + type4 = type[atom4-1] + c1 = classes[type1-1] + c2 = classes[type2-1] + c3 = classes[type3-1] + c4 = classes[type4-1] + + if (c1,c2,c3,c4) in ddict: m,params = ddict[(c1,c2,c3,c4)] + elif (c4,c3,c2,c1) in ddict: m,params = ddict[(c4,c3,c2,c1)] + else: + print "Dihedral not found",atom1,atom2,atom3,atom4,c1,c2,c3,c4 + sys.exit() + + if not flags[m]: + v1,v2,v3,v4,v5,v6,v7,v8,v9 = params[4:] + dparams.append((v1,v2,v3,v4,v5,v6,v7,v8,v9)) + flags[m] = len(dparams) + dtype.append(flags[m]) + +# ---------------------------------------- +# assign each atom to a Tinker group +# NOTE: doing this inside LAMMPS now +# comment out unless need to test +# ---------------------------------------- + +# ngroup = # of groups +# tgroup[i] = groupID (1 to Ngroups) for each atom +# use stack to store IDs of atoms to recursively loop over +# do not set tgroup for an atom if already assigned to a group +# only add atoms J (bonded to M) to stack +# whose Tinker type is in polgroup list for atom M's Tinker type + +#natoms = xyz.natoms +#id = xyz.id +#bonds = xyz.bonds +#ttype = xyz.type +#polgroup = prm.polgroup + +#tgroup = natoms*[0] +#ngroups = 0 + +#for i in id: +# if tgroup[i-1] > 0: continue +# +# ngroups += 1 +# groupID = ngroups +# stack = [i] +# while stack: +# m = stack.pop() +# if tgroup[m-1] > 0: continue +# tgroup[m-1] = groupID +# for j in bonds[m-1]: +# if tgroup[j-1] > 0: continue +# if ttype[j-1] not in polgroup[ttype[m-1]-1]: continue +# stack.append(j) + +# ---------------------------------------- +# write LAMMPS data file via Pizza.py data class +# ---------------------------------------- + +d = data() + +natoms = xyz.natoms +id = xyz.id +x = xyz.x +y = xyz.y +z = xyz.z +ttype = xyz.type + +nbonds = len(blist) +nangles = len(alist) +ndihedrals = len(dlist) + +# data file header values + +d.title = "LAMMPS data file created from Tinker %s and %s files\n" % \ + (xyzfile,prmfile) + +d.headers["atoms"] = natoms +d.headers["atom types"] = ntypes + +d.headers["xlo xhi"] = (boxlo[0],boxhi[0]) +d.headers["ylo yhi"] = (boxlo[1],boxhi[1]) +d.headers["zlo zhi"] = (boxlo[2],boxhi[2]) + +# data file sections + +lines = [] +for i,mass in enumerate(lmpmass): + line = "%d %s" % (i+1,mass) + lines.append(line+'\n') +d.sections["Masses"] = lines + +lines = [] +for i,one in enumerate(id): + line = "%d %d %d %g %s %s %s" % (one,molID[i],lmptype[i],0.0,x[i],y[i],z[i]) + lines.append(line+'\n') +d.sections["Atoms"] = lines + +lines = [] +for i,one in enumerate(ttype): + # comment out inclusion of Tinker group, now done by LAMMPS + #line = "%d %d %d" % (id[i],one,tgroup[i]) + line = "%d %d" % (id[i],one) + lines.append(line+'\n') +d.sections["Tinker Types"] = lines + +if nbonds: + d.headers["bonds"] = len(blist) + d.headers["bond types"] = len(bparams) + + lines = [] + for i,one in enumerate(bparams): + strone = [str(single) for single in one] + line = "%d %s" % (i+1,' '.join(strone)) + lines.append(line+'\n') + d.sections["Bond Coeffs"] = lines + + lines = [] + for i,one in enumerate(blist): + line = "%d %d %d %d" % (i+1,btype[i],one[0],one[1]) + lines.append(line+'\n') + d.sections["Bonds"] = lines + +if nangles: + d.headers["angles"] = len(alist) + d.headers["angle types"] = len(aparams) + + lines = [] + for i,one in enumerate(aparams): + strone = [str(single) for single in one] + line = "%d %s" % (i+1,' '.join(strone)) + lines.append(line+'\n') + d.sections["Angle Coeffs"] = lines + + #lines = [] + #for i,one in enumerate(aparams): + # line = "%d %g %g %g" % (i+1,0.0,0.0,0.0) + # lines.append(line+'\n') + #d.sections["BondBond Coeffs"] = lines + + #lines = [] + #for i,one in enumerate(aparams): + # line = "%d %g %g %g %g" % (i+1,0.0,0.0,0.0,0.0) + # lines.append(line+'\n') + # d.sections["BondAngle Coeffs"] = lines + + lines = [] + for i,one in enumerate(alist): + line = "%d %d %d %d %d" % (i+1,atype[i],one[0],one[1],one[2]) + lines.append(line+'\n') + d.sections["Angles"] = lines + +if ndihedrals: + d.headers["dihedrals"] = len(dlist) + d.headers["dihedral types"] = len(dparams) + + lines = [] + for i,one in enumerate(dparams): + line = "%d %s" % (i+1,' '.join(one)) + lines.append(line+'\n') + d.sections["Dihedral Coeffs"] = lines + + lines = [] + for i,one in enumerate(dlist): + line = "%d %d %d %d %d %d" % (i+1,dtype[i],one[0],one[1],one[2],one[3]) + lines.append(line+'\n') + d.sections["Dihedrals"] = lines + +d.write(datafile) + +# print stats to screen + +print "Natoms =",natoms +print "Ntypes =",ntypes +print "Tinker XYZ types =",len(tink2lmp) +print "Tinker PRM types =",prm.ntypes +#print "Tinker groups =",ngroups +print "Nmol =",nmol +print "Nbonds =",len(blist) +print "Nangles =",len(alist) +print "Ndihedrals =",len(dlist) +print "Nbondtypes =",len(bparams) +print "Nangletypes =",len(aparams) +print "Ndihedraltypes =",len(dparams) From bed13d9c635915f68db066c02d10b996e8ed6203 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Wed, 25 Aug 2021 14:09:58 -0600 Subject: [PATCH 029/585] simply example scripts --- examples/amoeba/in.ubiquitin | 84 +++------------------------ examples/amoeba/in.water_box | 96 +++++-------------------------- examples/amoeba/in.water_dimer | 92 +++++------------------------- examples/amoeba/in.water_hexamer | 97 ++++++-------------------------- 4 files changed, 53 insertions(+), 316 deletions(-) diff --git a/examples/amoeba/in.ubiquitin b/examples/amoeba/in.ubiquitin index 7f61edabab..e6f9893e41 100644 --- a/examples/amoeba/in.ubiquitin +++ b/examples/amoeba/in.ubiquitin @@ -1,19 +1,12 @@ -# default cmd-line variable settings - -variable a index "" -variable diff index 0 +# solvated ubiquitin molecule with AMOEBA force field units real boundary p p p -atom_modify sort 0 0.0 -comm_modify cutoff 5.0 atom_style amoeba -special_bonds lj/coul 0.5 0.5 0.5 one/five yes bond_style class2 angle_style amoeba -#dihedral_style nharmonic dihedral_style none # per-atom properties required by AMOEBA or HIPPO @@ -23,82 +16,19 @@ fix extra all property/atom & i_amgroup i_ired i_xaxis i_yaxis i_zaxis d_pval ghost yes fix extra2 all property/atom i_polaxe -read_data data.${struc}.angles fix amtype NULL "Tinker Types" -#read_data data.watersmall fix amtype NULL "Tinker Types" -#read_data data.water_hexamer fix amtype NULL "Tinker Types" +read_data data.ubiquitin fix amtype NULL "Tinker Types" -# insure all 1-2,1-3,1-4,1-5 are in Tinker neigh list +pair_style amoeba +pair_coeff * * amoeba_ubiquitin.prm amoeba_ubiquitin.key special_bonds lj/coul 0.5 0.5 0.5 one/five yes -# force field terms -# depends on 2 command-line variables -# ff = amoeba or hippo, a = args for pair_style - -if "${ff} == amoeba" then & -"pair_style amoeba $a" & -"pair_coeff * * amoeba.prm amoeba.key" - -if "${ff} == hippo" then & -"pair_style hippo $a" & -"pair_coeff * * hippo.prm hippo.key" - -if "${ff} == amoeba_direct" then & -"pair_style amoeba $a" & -"pair_coeff * * amoeba_direct.prm amoeba_direct.key" - -if "${ff} == hippo_direct" then & -"pair_style hippo $a" & -"pair_coeff * * hippo_direct.prm hippo_direct.key" - -if "${ff} == amoeba_opt" then & -"pair_style amoeba $a" & -"pair_coeff * * amoeba.prm amoeba_opt.key" - -if "${ff} == hippo_opt" then & -"pair_style hippo $a" & -"pair_coeff * * hippo.prm hippo_opt.key" - -# optional turn off angle and dihedral - -#angle_style none -dihedral_style none - -# numeric difference of forces - -#compute nd all pe -#fix nd all numdiff ${diff} 1.0e-5 nd -#variable dx atom abs(fx+f_nd[1]) -#variable dy atom abs(fy+f_nd[2]) -#variable dz atom abs(fz+f_nd[3]) -#compute rd all reduce max v_dx v_dy v_dz - -# setup force components this way so can dump them - -fix fhal all store/state 0 fx fy fz -fix frepulse all store/state 0 fx fy fz -fix fdisp all store/state 0 fx fy fz -fix fpolar all store/state 0 fx fy fz -fix fmpole all store/state 0 fx fy fz -fix fqxfer all store/state 0 fx fy fz - -dump 1 all custom 1 ${dumpfile} id type x y z fx fy fz & -# f_fhal[1] f_fhal[2] f_fhal[3] & -# f_fdisp[1] f_fdisp[2] f_fdisp[3] & -# f_frepulse[1] f_frepulse[2] f_frepulse[3] & -# f_fpolar[1] f_fpolar[2] f_fpolar[3] & -# f_fmpole[1] f_fmpole[2] f_fmpole[3] & -# f_fqxfer[1] f_fqxfer[2] f_fqxfer[3] -# f_nd[1] f_nd[2] f_nd[3] - -dump_modify 1 format float "%20.16g" sort id +# thermo output compute virial all pressure NULL virial -# thermo output - -thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] #c_rd[*] -thermo_modify format float "%20.16g" +thermo_style custom step temp epair ebond eangle edihed eimp & + emol etotal press c_virial[*] # 0-step run diff --git a/examples/amoeba/in.water_box b/examples/amoeba/in.water_box index 7175ec6750..d4dd40edcd 100644 --- a/examples/amoeba/in.water_box +++ b/examples/amoeba/in.water_box @@ -1,20 +1,12 @@ -# test of HIPPO water dimer system - -# default cmd-line variable settings - -variable a index "" -variable diff index 0 +# water box with AMOEBA or HIPPO units real -atom_style full boundary p p p -atom_modify sort 0 0.0 - -atom_style amoeba -special_bonds lj/coul 0.5 0.5 0.5 one/five yes +atom_style amoeba bond_style class2 angle_style amoeba +dihedral_style none # per-atom properties required by AMOEBA or HIPPO @@ -23,83 +15,25 @@ fix extra all property/atom & i_amgroup i_ired i_xaxis i_yaxis i_zaxis d_pval ghost yes fix extra2 all property/atom i_polaxe -read_data data.${struc}.angles fix amtype NULL "Tinker Types" -#read_data data.watersmall fix amtype NULL "Tinker Types" -#read_data data.water_hexamer fix amtype NULL "Tinker Types" +# read data file -# insure all 1-2,1-3,1-4 are in Tinker neigh list +read_data data.water_box.amoeba fix amtype NULL "Tinker Types" +#read_data data.water_box.hippo fix amtype NULL "Tinker Types" -special_bonds lj/coul 0.5 0.5 0.5 +# force field -# force field terms -# depends on 2 command-line variables -# ff = amoeba or hippo, a = args for pair_style +pair_style amoeba +pair_coeff * * amoeba_water.prm amoeba_water.key -if "${ff} == amoeba" then & -"pair_style amoeba $a" & -"pair_coeff * * amoeba.prm amoeba.key" - -if "${ff} == hippo" then & -"pair_style hippo $a" & -"pair_coeff * * hippo.prm hippo.key" - -if "${ff} == amoeba_direct" then & -"pair_style amoeba $a" & -"pair_coeff * * amoeba_direct.prm amoeba_direct.key" - -if "${ff} == hippo_direct" then & -"pair_style hippo $a" & -"pair_coeff * * hippo_direct.prm hippo_direct.key" - -if "${ff} == amoeba_opt" then & -"pair_style amoeba $a" & -"pair_coeff * * amoeba.prm amoeba_opt.key" - -if "${ff} == hippo_opt" then & -"pair_style hippo $a" & -"pair_coeff * * hippo.prm hippo_opt.key" - - -# turn off bond/angle interactions for now - -#bond_style none -#angle_style none - -# numeric difference of forces - -#compute nd all pe -#fix nd all numdiff ${diff} 1.0e-5 nd -#variable dx atom abs(fx+f_nd[1]) -#variable dy atom abs(fy+f_nd[2]) -#variable dz atom abs(fz+f_nd[3]) -#compute rd all reduce max v_dx v_dy v_dz - -# setup force components this way so can dump them - -fix fhal all store/state 0 fx fy fz -fix frepulse all store/state 0 fx fy fz -fix fdisp all store/state 0 fx fy fz -fix fpolar all store/state 0 fx fy fz -fix fmpole all store/state 0 fx fy fz -fix fqxfer all store/state 0 fx fy fz - -dump 1 all custom 1 ${dumpfile} id type x y z fx fy fz & -# f_fhal[1] f_fhal[2] f_fhal[3] & -# f_fdisp[1] f_fdisp[2] f_fdisp[3] & -# f_frepulse[1] f_frepulse[2] f_frepulse[3] & -# f_fpolar[1] f_fpolar[2] f_fpolar[3] & -# f_fmpole[1] f_fmpole[2] f_fmpole[3] & -# f_fqxfer[1] f_fqxfer[2] f_fqxfer[3] & -# f_nd[1] f_nd[2] f_nd[3] - -dump_modify 1 format float "%15.10g" sort id - -compute virial all pressure NULL virial +#pair_style hippo +#pair_coeff * * hippo_water.prm hippo_water.key # thermo output -thermo_style custom step temp epair ebond eanble etotal press c_virial[*] #c_rd[*] -thermo_modify format float "%15.10g" +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp & + emol etotal press c_virial[*] # 0-step run diff --git a/examples/amoeba/in.water_dimer b/examples/amoeba/in.water_dimer index 30b5dc71b2..4a8d07743f 100644 --- a/examples/amoeba/in.water_dimer +++ b/examples/amoeba/in.water_dimer @@ -1,17 +1,9 @@ -# test of HIPPO water dimer system - -# default cmd-line variable settings - -variable a index "" -variable diff index 0 +# water dimer with AMOEBA or HIPPO units real -atom_style full boundary s s s -atom_style amoeba -special_bonds lj/coul 0.5 0.5 0.5 one/five yes - +atom_style amoeba bond_style class2 angle_style amoeba dihedral_style none @@ -23,81 +15,25 @@ fix extra all property/atom & i_amgroup i_ired i_xaxis i_yaxis i_zaxis d_pval ghost yes fix extra2 all property/atom i_polaxe -read_data data.${struc}.bonds fix amtype NULL "Tinker Types" -#read_data data.watersmall fix amtype NULL "Tinker Types" -#read_data data.water_hexamer fix amtype NULL "Tinker Types" +# read data file -# insure all 1-2,1-3,1-4 are in Tinker neigh list +read_data data.water_dimer.amoeba fix amtype NULL "Tinker Types" +#read_data data.water_dimer.hippo fix amtype NULL "Tinker Types" -special_bonds lj/coul 0.5 0.5 0.5 +# force field -# force field terms -# depends on 2 command-line variables -# ff = amoeba or hippo, a = args for pair_style +pair_style amoeba +pair_coeff * * amoeba_water.prm amoeba_water.key -if "${ff} == amoeba" then & -"pair_style amoeba $a" & -"pair_coeff * * amoeba.prm amoeba.key" - -if "${ff} == hippo" then & -"pair_style hippo $a" & -"pair_coeff * * hippo.prm hippo.key" - -if "${ff} == amoeba_direct" then & -"pair_style amoeba $a" & -"pair_coeff * * amoeba_direct.prm amoeba_direct.key" - -if "${ff} == hippo_direct" then & -"pair_style hippo $a" & -"pair_coeff * * hippo_direct.prm hippo_direct.key" - -if "${ff} == amoeba_opt" then & -"pair_style amoeba $a" & -"pair_coeff * * amoeba.prm amoeba_opt.key" - -if "${ff} == hippo_opt" then & -"pair_style hippo $a" & -"pair_coeff * * hippo.prm hippo_opt.key" - - -# turn off bond/angle interactions for now - -#bond_style none -#angle_style none - -# numeric difference of forces - -#compute nd all pe -#fix nd all numdiff ${diff} 1.0e-5 nd -#variable dx atom abs(fx+f_nd[1]) -#variable dy atom abs(fy+f_nd[2]) -#variable dz atom abs(fz+f_nd[3]) -#compute rd all reduce max v_dx v_dy v_dz - -# setup force components this way so can dump them - -fix fhal all store/state 0 fx fy fz -fix frepulse all store/state 0 fx fy fz -fix fdisp all store/state 0 fx fy fz -fix fpolar all store/state 0 fx fy fz -fix fmpole all store/state 0 fx fy fz -fix fqxfer all store/state 0 fx fy fz - -dump 1 all custom 1 ${dumpfile} id type fx fy fz & -# f_fhal[1] f_fhal[2] f_fhal[3] & -# f_fdisp[1] f_fdisp[2] f_fdisp[3] & -# f_frepulse[1] f_frepulse[2] f_frepulse[3] & -# f_fpolar[1] f_fpolar[2] f_fpolar[3] & -# f_fmpole[1] f_fmpole[2] f_fmpole[3] & -# f_fqxfer[1] f_fqxfer[2] f_fqxfer[3] & -# f_nd[1] f_nd[2] f_nd[3] - -dump_modify 1 format float "%15.10g" sort id +#pair_style hippo +#pair_coeff * * hippo_water.prm hippo_water.key # thermo output -thermo_style custom step temp epair ebond eangle etotal press #c_rd[*] -thermo_modify format float "%15.10g" +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp & + emol etotal press c_virial[*] # 0-step run diff --git a/examples/amoeba/in.water_hexamer b/examples/amoeba/in.water_hexamer index 580b8a6849..59c8d4ce12 100644 --- a/examples/amoeba/in.water_hexamer +++ b/examples/amoeba/in.water_hexamer @@ -1,19 +1,12 @@ -# test of HIPPO water dimer system - -# default cmd-line variable settings - -variable a index "" -variable diff index 0 +# water hexamer with AMOEBA or HIPPO units real -atom_style full boundary s s s -atom_style amoeba -special_bonds lj/coul 0.5 0.5 0.5 one/five yes - -bond_style harmonic -angle_style harmonic +atom_style amoeba +bond_style class2 +angle_style amoeba +dihedral_style none # per-atom properties required by AMOEBA or HIPPO @@ -22,81 +15,25 @@ fix extra all property/atom & i_amgroup i_ired i_xaxis i_yaxis i_zaxis d_pval ghost yes fix extra2 all property/atom i_polaxe -read_data data.${struc} fix amtype NULL "Tinker Types" -#read_data data.watersmall fix amtype NULL "Tinker Types" -#read_data data.water_hexamer fix amtype NULL "Tinker Types" +# read data file -# insure all 1-2,1-3,1-4 are in Tinker neigh list +read_data data.water_hexamer.amoeba fix amtype NULL "Tinker Types" +#read_data data.water_hexamer.hippo fix amtype NULL "Tinker Types" -special_bonds lj/coul 0.5 0.5 0.5 +# force field -# force field terms -# depends on 2 command-line variables -# ff = amoeba or hippo, a = args for pair_style +pair_style amoeba +pair_coeff * * amoeba_water.prm amoeba_water.key -if "${ff} == amoeba" then & -"pair_style amoeba $a" & -"pair_coeff * * amoeba.prm amoeba.key" - -if "${ff} == hippo" then & -"pair_style hippo $a" & -"pair_coeff * * hippo.prm hippo.key" - -if "${ff} == amoeba_direct" then & -"pair_style amoeba $a" & -"pair_coeff * * amoeba_direct.prm amoeba_direct.key" - -if "${ff} == hippo_direct" then & -"pair_style hippo $a" & -"pair_coeff * * hippo_direct.prm hippo_direct.key" - -if "${ff} == amoeba_opt" then & -"pair_style amoeba $a" & -"pair_coeff * * amoeba.prm amoeba_opt.key" - -if "${ff} == hippo_opt" then & -"pair_style hippo $a" & -"pair_coeff * * hippo.prm hippo_opt.key" - - -# turn off bond/angle interactions for now - -bond_style none -angle_style none - -# numeric difference of forces - -#compute nd all pe -#fix nd all numdiff ${diff} 1.0e-5 nd -#variable dx atom abs(fx+f_nd[1]) -#variable dy atom abs(fy+f_nd[2]) -#variable dz atom abs(fz+f_nd[3]) -#compute rd all reduce max v_dx v_dy v_dz - -# setup force components this way so can dump them - -fix fhal all store/state 0 fx fy fz -fix frepulse all store/state 0 fx fy fz -fix fdisp all store/state 0 fx fy fz -fix fpolar all store/state 0 fx fy fz -fix fmpole all store/state 0 fx fy fz -fix fqxfer all store/state 0 fx fy fz - -dump 1 all custom 1 ${dumpfile} id type x y z fx fy fz & -# f_fhal[1] f_fhal[2] f_fhal[3] & -# f_fdisp[1] f_fdisp[2] f_fdisp[3] & -# f_frepulse[1] f_frepulse[2] f_frepulse[3] & -# f_fpolar[1] f_fpolar[2] f_fpolar[3] & -# f_fmpole[1] f_fmpole[2] f_fmpole[3] & -# f_fqxfer[1] f_fqxfer[2] f_fqxfer[3] & -# f_nd[1] f_nd[2] f_nd[3] - -dump_modify 1 format float "%15.10g" sort id +#pair_style hippo +#pair_coeff * * hippo_water.prm hippo_water.key # thermo output -thermo_style custom step temp epair emol etotal press #c_rd[*] -thermo_modify format float "%15.10g" +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp & + emol etotal press c_virial[*] # 0-step run From 9c095e8d765cd43afaecdaee28930d2398f8cafe Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Wed, 25 Aug 2021 16:29:22 -0600 Subject: [PATCH 030/585] new AMOEBA package --- src/AMOEBA/amoeba_charge_transfer.cpp | 173 ++ src/AMOEBA/amoeba_convolution.cpp | 825 +++++++++ src/AMOEBA/amoeba_convolution.h | 88 + src/AMOEBA/amoeba_dispersion.cpp | 424 +++++ src/AMOEBA/amoeba_file.cpp | 1381 +++++++++++++++ src/AMOEBA/amoeba_hal.cpp | 212 +++ src/AMOEBA/amoeba_induce.cpp | 1994 +++++++++++++++++++++ src/AMOEBA/amoeba_kspace.cpp | 1241 +++++++++++++ src/AMOEBA/amoeba_multipole.cpp | 1038 +++++++++++ src/AMOEBA/amoeba_polar.cpp | 2224 ++++++++++++++++++++++++ src/AMOEBA/amoeba_repulsion.cpp | 581 +++++++ src/AMOEBA/amoeba_utils.cpp | 1249 +++++++++++++ src/AMOEBA/angle_amoeba.cpp | 535 ++++++ src/AMOEBA/angle_amoeba.h | 58 + src/AMOEBA/atom_vec_amoeba.cpp | 237 +++ src/AMOEBA/atom_vec_amoeba.h | 57 + src/AMOEBA/pair_amoeba.cpp | 2317 +++++++++++++++++++++++++ src/AMOEBA/pair_amoeba.h | 500 ++++++ src/AMOEBA/pair_hippo.cpp | 24 + src/AMOEBA/pair_hippo.h | 39 + 20 files changed, 15197 insertions(+) create mode 100644 src/AMOEBA/amoeba_charge_transfer.cpp create mode 100644 src/AMOEBA/amoeba_convolution.cpp create mode 100644 src/AMOEBA/amoeba_convolution.h create mode 100644 src/AMOEBA/amoeba_dispersion.cpp create mode 100644 src/AMOEBA/amoeba_file.cpp create mode 100644 src/AMOEBA/amoeba_hal.cpp create mode 100644 src/AMOEBA/amoeba_induce.cpp create mode 100644 src/AMOEBA/amoeba_kspace.cpp create mode 100644 src/AMOEBA/amoeba_multipole.cpp create mode 100644 src/AMOEBA/amoeba_polar.cpp create mode 100644 src/AMOEBA/amoeba_repulsion.cpp create mode 100644 src/AMOEBA/amoeba_utils.cpp create mode 100644 src/AMOEBA/angle_amoeba.cpp create mode 100644 src/AMOEBA/angle_amoeba.h create mode 100644 src/AMOEBA/atom_vec_amoeba.cpp create mode 100644 src/AMOEBA/atom_vec_amoeba.h create mode 100644 src/AMOEBA/pair_amoeba.cpp create mode 100644 src/AMOEBA/pair_amoeba.h create mode 100644 src/AMOEBA/pair_hippo.cpp create mode 100644 src/AMOEBA/pair_hippo.h diff --git a/src/AMOEBA/amoeba_charge_transfer.cpp b/src/AMOEBA/amoeba_charge_transfer.cpp new file mode 100644 index 0000000000..b815d06f83 --- /dev/null +++ b/src/AMOEBA/amoeba_charge_transfer.cpp @@ -0,0 +1,173 @@ +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#include "pair_amoeba.h" +#include +#include "atom.h" +#include "neigh_list.h" +#include "memory.h" + +using namespace LAMMPS_NS; + +enum{VDWL,REPULSE,QFER,DISP,MPOLE,POLAR,USOLV,DISP_LONG,MPOLE_LONG,POLAR_LONG}; + +/* ---------------------------------------------------------------------- + charge_transfer = HIPPO charge transfer forces + adapted from Tinker echgtrn1b() routine +------------------------------------------------------------------------- */ + +void PairAmoeba::charge_transfer() +{ + int i,j,ii,jj,itype,jtype,iclass,jclass; + int special_flag; + double e,de,felec,fgrp; + double rr1,r,r2; + double r3,r4,r5; + double xi,yi,zi; + double xr,yr,zr; + double chgi,chgj; + double chgij; + double alphai,alphaj; + double alphaij; + double expi,expj; + double expij; + double frcx,frcy,frcz; + double vxx,vyy,vzz; + double vxy,vxz,vyz; + double taper,dtaper; + double factor_mpole; + + int inum,jnum; + int *ilist,*jlist,*numneigh,**firstneigh; + + // set cutoffs and taper coeffs + + choose(QFER); + + // owned atoms + + double **x = atom->x; + int nlocal = atom->nlocal; + + // neigh list + + inum = list->inum; + ilist = list->ilist; + numneigh = list->numneigh; + firstneigh = list->firstneigh; + + // set the energy unit conversion factor + + felec = electric / am_dielectric; + + // find charge transfer energy and derivatives via neighbor list + + for (ii = 0; ii < inum; ii++) { + i = ilist[ii]; + itype = amtype[i]; + iclass = amtype2class[itype]; + jlist = firstneigh[i]; + jnum = numneigh[i]; + + xi = x[i][0]; + yi = x[i][1]; + zi = x[i][2]; + chgi = chgct[iclass]; + alphai = dmpct[iclass]; + if (alphai == 0.0) alphai = 100.0; + + // evaluate all sites within the cutoff distance + + for (jj = 0; jj < jnum; jj++) { + j = jlist[jj]; + factor_mpole = special_mpole[sbmask15(j)]; + if (factor_mpole == 0.0) continue; + j &= NEIGHMASK15; + + xr = x[j][0] - xi; + yr = x[j][1] - yi; + zr = x[j][2] - zi; + r2 = xr*xr + yr* yr + zr*zr; + if (r2 > off2) continue; + + jtype = amtype[j]; + jclass = amtype2class[jtype]; + + r = sqrt(r2); + rr1 = 1.0 / r; + chgj = chgct[jclass]; + alphaj = dmpct[jclass]; + if (alphaj == 0.0) alphaj = 100.0; + + expi = exp(-alphai*r); + expj = exp(-alphaj*r); + e = -chgi*expj - chgj*expi; + de = chgi*expj*alphaj + chgj*expi*alphai; + e = felec * e * factor_mpole; + de = felec * de * factor_mpole; + + // use energy switching if near the cutoff distance + + if (r2 > cut2) { + r3 = r2 * r; + r4 = r2 * r2; + r5 = r2 * r3; + taper = c5*r5 + c4*r4 + c3*r3 + c2*r2 + c1*r + c0; + dtaper = 5.0*c5*r4 + 4.0*c4*r3 + 3.0*c3*r2 + 2.0*c2*r + c1; + de = e*dtaper + de*taper; + e *= taper; + } + + eqxfer += e; + + // compute the force components for this interaction + + frcx = de * xr * rr1; + frcy = de * yr * rr1; + frcz = de * zr * rr1; + + // increment the total charge transfer energy and derivatives + + fqxfer[i][0] -= frcx; + fqxfer[i][1] -= frcy; + fqxfer[i][2] -= frcz; + fqxfer[j][0] += frcx; + fqxfer[j][1] += frcy; + fqxfer[j][2] += frcz; + + // increment the internal virial tensor components + + vxx = xr * frcx; + vxy = yr * frcx; + vxz = zr * frcx; + vyy = yr * frcy; + vyz = zr * frcy; + vzz = zr * frcz; + + virqxfer[0] += vxx; + virqxfer[1] += vyy; + virqxfer[2] += vzz; + virqxfer[3] += vxy; + virqxfer[4] += vxz; + virqxfer[5] += vyz; + + // energy = e + // virial = 6-vec vir + // NOTE: add tally function + + if (evflag) { + } + } + } +} + diff --git a/src/AMOEBA/amoeba_convolution.cpp b/src/AMOEBA/amoeba_convolution.cpp new file mode 100644 index 0000000000..db71e6009a --- /dev/null +++ b/src/AMOEBA/amoeba_convolution.cpp @@ -0,0 +1,825 @@ +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#include "amoeba_convolution.h" +#include "domain.h" +#include "comm.h" +#include "update.h" +#include "neighbor.h" +#include "fft3d_wrap.h" +#include "remap_wrap.h" +#include "gridcomm.h" +#include "memory.h" + +using namespace LAMMPS_NS; + +// DEBUG + +#define DEBUG 0 + +char *labels[7] = + {(char *) "MPOLE_GRID", (char *) "POLAR_GRID", + (char *) "POLAR_GRIDC", (char *) "DISP_GRID", + (char *) "INDUCE_GRID", (char *) "INDUCE_GRIDC"}; + +enum{GRIDBRICK_OUT,GRIDBRICK_IN,FFT,CFFT1,CFFT2}; + +// END DEBUG + +enum{MPOLE_GRID,POLAR_GRID,POLAR_GRIDC,DISP_GRID,INDUCE_GRID,INDUCE_GRIDC}; + +//#define SCALE 1 +#define SCALE 0 + +#ifdef FFT_SINGLE +#define ZEROF 0.0f +#define ONEF 1.0f +#else +#define ZEROF 0.0 +#define ONEF 1.0 +#endif + +/* ---------------------------------------------------------------------- + partition an FFT grid across processors + both for a brick and FFT x pencil decomposition + nx,nz,nz = global FFT grid size + order = size of stencil in each dimension that maps atoms to grid + adapted from PPPM::set_grid_local() +------------------------------------------------------------------------- */ + +AmoebaConvolution::AmoebaConvolution(LAMMPS *lmp, Pair *pair, + int nx_caller, int ny_caller, int nz_caller, + int order_caller, int which_caller) : + Pointers(lmp) +{ + amoeba = pair; + nx = nx_caller; + ny = ny_caller; + nz = nz_caller; + order = order_caller; + which = which_caller; + + flag3d = 1; + if (which == POLAR_GRIDC || which == INDUCE_GRIDC) flag3d = 0; + + // NOTE: worry about overflow + + nfft_global = nx * ny * nz; + + // global indices of grid range from 0 to N-1 + // nlo_in,nhi_in = lower/upper limits of the 3d sub-brick of + // global grid that I own without ghost cells + // both non-tiled and tiled proc layouts use 0-1 fractional subdomain info + + if (comm->layout != Comm::LAYOUT_TILED) { + nxlo_in = static_cast (comm->xsplit[comm->myloc[0]] * nx); + nxhi_in = static_cast (comm->xsplit[comm->myloc[0]+1] * nx) - 1; + nylo_in = static_cast (comm->ysplit[comm->myloc[1]] * ny); + nyhi_in = static_cast (comm->ysplit[comm->myloc[1]+1] * ny) - 1; + nzlo_in = static_cast (comm->zsplit[comm->myloc[2]] * nz); + nzhi_in = static_cast (comm->zsplit[comm->myloc[2]+1] * nz) - 1; + + } else { + nxlo_in = static_cast (comm->mysplit[0][0] * nx); + nxhi_in = static_cast (comm->mysplit[0][1] * nx) - 1; + nylo_in = static_cast (comm->mysplit[1][0] * ny); + nyhi_in = static_cast (comm->mysplit[1][1] * ny) - 1; + nzlo_in = static_cast (comm->mysplit[2][0] * nz); + nzhi_in = static_cast (comm->mysplit[2][1] * nz) - 1; + } + + // nlower,nupper = stencil size for mapping particles to FFT grid + + int nlower = -(order-1)/2; + int nupper = order/2; + + // nlo_out,nhi_out = lower/upper limits of the 3d sub-brick of + // global grid that my particles can contribute charge to + // effectively nlo_in,nhi_in + ghost cells + // nlo,nhi = global coords of grid pt to "lower left" of smallest/largest + // position a particle in my box can be at + // dist[3] = particle position bound = subbox + skin/2.0 + // convert to triclinic if necessary + // nlo_out,nhi_out = nlo,nhi + stencil size for particle mapping + // NOTE: this needs to be computed same as IGRID in amoeba + + double *prd,*boxlo,*sublo,*subhi; + int triclinic = domain->triclinic; + + if (triclinic == 0) { + prd = domain->prd; + boxlo = domain->boxlo; + sublo = domain->sublo; + subhi = domain->subhi; + } else { + prd = domain->prd_lamda; + boxlo = domain->boxlo_lamda; + sublo = domain->sublo_lamda; + subhi = domain->subhi_lamda; + } + + double xprd = prd[0]; + double yprd = prd[1]; + double zprd = prd[2]; + + double dist[3] = {0.0,0.0,0.0}; + double cuthalf = 0.5*neighbor->skin; + if (triclinic == 0) dist[0] = dist[1] = dist[2] = cuthalf; + else kspacebbox(cuthalf,&dist[0]); + + int nlo,nhi; + + nlo = static_cast ((sublo[0]-dist[0]-boxlo[0]) * nx/xprd); + nhi = static_cast ((subhi[0]+dist[0]-boxlo[0]) * nx/xprd); + nxlo_out = nlo + nlower; + nxhi_out = nhi + nupper; + + nlo = static_cast ((sublo[1]-dist[1]-boxlo[1]) * ny/yprd); + nhi = static_cast ((subhi[1]+dist[1]-boxlo[1]) * ny/yprd); + nylo_out = nlo + nlower; + nyhi_out = nhi + nupper; + + nlo = static_cast ((sublo[2]-dist[2]-boxlo[2]) * nz/zprd); + nhi = static_cast ((subhi[2]+dist[2]-boxlo[2]) * nz/zprd); + nzlo_out = nlo + nlower; + nzhi_out = nhi + nupper; + + // x-pencil decomposition of FFT mesh + // global indices range from 0 to N-1 + // each proc owns entire x-dimension, clumps of columns in y,z dimensions + // npey_fft,npez_fft = # of procs in y,z dims + // if nprocs is small enough, proc can own 1 or more entire xy planes, + // else proc owns 2d sub-blocks of yz plane + // me_y,me_z = which proc (0-npe_fft-1) I am in y,z dimensions + // nlo_fft,nhi_fft = lower/upper limit of the section + // of the global FFT mesh that I own in x-pencil decomposition + + int me = comm->me; + int nprocs = comm->nprocs; + + int npey_fft,npez_fft; + if (nz >= nprocs) { + npey_fft = 1; + npez_fft = nprocs; + } else procs2grid2d(nprocs,ny,nz,npey_fft,npez_fft); + + int me_y = me % npey_fft; + int me_z = me / npey_fft; + + nxlo_fft = 0; + nxhi_fft = nx - 1; + nylo_fft = me_y*ny/npey_fft; + nyhi_fft = (me_y+1)*ny/npey_fft - 1; + nzlo_fft = me_z*nz/npez_fft; + nzhi_fft = (me_z+1)*nz/npez_fft - 1; + + // grid sizes + // nbrick_owned = owned grid points in brick decomp + // nbrick_ghosts = owned + ghost grid points in grid decomp + // nfft_owned = owned grid points in FFT decomp + // ngrid_either = max of nbrick_onwed and nfft_owned + // nfft = total FFT grid points + + nbrick_owned = (nxhi_in-nxlo_in+1) * (nyhi_in-nylo_in+1) * + (nzhi_in-nzlo_in+1); + nbrick_ghosts = (nxhi_out-nxlo_out+1) * (nyhi_out-nylo_out+1) * + (nzhi_out-nzlo_out+1); + nfft_owned = (nxhi_fft-nxlo_fft+1) * (nyhi_fft-nylo_fft+1) * + (nzhi_fft-nzlo_fft+1); + + ngrid_either = MAX(nbrick_owned,nfft_owned); + + // instantiate FFT, GridComm, and Remap + + int tmp; + + fft1 = new FFT3d(lmp,world,nx,ny,nz, + nxlo_fft,nxhi_fft,nylo_fft,nyhi_fft,nzlo_fft,nzhi_fft, + nxlo_fft,nxhi_fft,nylo_fft,nyhi_fft,nzlo_fft,nzhi_fft, + 1,0,&tmp,0); + // 0,0,&tmp,0); + + fft2 = new FFT3d(lmp,world,nx,ny,nz, + nxlo_fft,nxhi_fft,nylo_fft,nyhi_fft,nzlo_fft,nzhi_fft, + nxlo_in,nxhi_in,nylo_in,nyhi_in,nzlo_in,nzhi_in, + //1,0,&tmp,0); + 0,0,&tmp,0); + + gc = new GridComm(lmp,world,nx,ny,nz, + nxlo_in,nxhi_in,nylo_in,nyhi_in,nzlo_in,nzhi_in, + nxlo_out,nxhi_out,nylo_out,nyhi_out,nzlo_out,nzhi_out); + + int nqty = flag3d ? 1 : 2; + remap = new Remap(lmp,world, + nxlo_in,nxhi_in,nylo_in,nyhi_in,nzlo_in,nzhi_in, + nxlo_fft,nxhi_fft,nylo_fft,nyhi_fft,nzlo_fft,nzhi_fft, + nqty,0,0,FFT_PRECISION,0); + + // memory allocations + + if (flag3d) { + memory->create3d_offset(grid_brick,nzlo_out,nzhi_out,nylo_out,nyhi_out, + nxlo_out,nxhi_out,"amoeba:grid_brick"); + grid_brick_start = &grid_brick[nzlo_out][nylo_out][nxlo_out]; + cgrid_brick = NULL; + } else { + memory->create4d_offset_last(cgrid_brick,nzlo_out,nzhi_out,nylo_out,nyhi_out, + nxlo_out,nxhi_out,2,"amoeba:cgrid_brick"); + grid_brick_start = &cgrid_brick[nzlo_out][nylo_out][nxlo_out][0]; + grid_brick = NULL; + } + + memory->create(grid_fft,ngrid_either,"amoeba:grid_fft"); + memory->create(cfft,2*ngrid_either,"amoeba:cfft"); + + int ngc_buf1,ngc_buf2; + gc->setup(ngc_buf1,ngc_buf2); + memory->create(gc_buf1,nqty*ngc_buf1,"amoeba:gc_buf1"); + memory->create(gc_buf2,nqty*ngc_buf2,"amoeba:gc_buf2"); + + memory->create(remap_buf,nqty*nfft_owned,"amoeba:remap_buf"); +} + +/* ---------------------------------------------------------------------- + free all memory +------------------------------------------------------------------------- */ + +AmoebaConvolution::~AmoebaConvolution() +{ + memory->destroy3d_offset(grid_brick,nzlo_out,nylo_out,nxlo_out); + memory->destroy4d_offset_last(cgrid_brick,nzlo_out,nylo_out,nxlo_out); + memory->destroy(grid_fft); + memory->destroy(cfft); + memory->destroy(gc_buf1); + memory->destroy(gc_buf2); + memory->destroy(remap_buf); + + delete fft1; + delete fft2; + delete gc; + delete remap; +} + +/* ---------------------------------------------------------------------- + zero brick grid, including ghosts + can be 3d real or 4d complex array + return pointer to data in brick grid, caller casts to 3d or 4d +------------------------------------------------------------------------- */ + +void *AmoebaConvolution::zero() +{ + if (flag3d) return zero_3d(); + return zero_4d(); +} + +/* ---------------------------------------------------------------------- */ + +void *AmoebaConvolution::zero_3d() +{ + if (!grid_brick) return NULL; + memset(&(grid_brick[nzlo_out][nylo_out][nxlo_out]),0, + nbrick_ghosts*sizeof(FFT_SCALAR)); + return (void *) grid_brick; +} + +/* ---------------------------------------------------------------------- */ + +void *AmoebaConvolution::zero_4d() +{ + if (!cgrid_brick) return NULL; + memset(&(cgrid_brick[nzlo_out][nylo_out][nxlo_out][0]),0, + 2*nbrick_ghosts*sizeof(FFT_SCALAR)); + return (void *) cgrid_brick; +} + +/* ---------------------------------------------------------------------- + perform pre-convolution grid operations + can be 3d real or 4d complex array + return pointer to complex cfft vector +------------------------------------------------------------------------- */ + +FFT_SCALAR *AmoebaConvolution::pre_convolution() +{ + if (flag3d) return pre_convolution_3d(); + return pre_convolution_4d(); +} + +/* ---------------------------------------------------------------------- + perform pre-convolution grid operations for 3d grid_brick array +------------------------------------------------------------------------- */ + +FFT_SCALAR *AmoebaConvolution::pre_convolution_3d() +{ + int ix,iy,iz,n; + + // reverse comm for 3d brick grid + ghosts + + if (DEBUG) debug_scalar(GRIDBRICK_OUT,"PRE Convo / PRE GridComm"); + + gc->reverse_comm(amoeba,1,sizeof(FFT_SCALAR),which, + gc_buf1,gc_buf2,MPI_FFT_SCALAR); + + if (DEBUG) debug_scalar(GRIDBRICK_IN,"PRE Convo / POST GridComm"); + if (DEBUG) debug_file(GRIDBRICK_IN,"pre.convo.post.gridcomm"); + + // copy owned 3d brick grid values to FFT grid + + n = 0; + for (iz = nzlo_in; iz <= nzhi_in; iz++) + for (iy = nylo_in; iy <= nyhi_in; iy++) + for (ix = nxlo_in; ix <= nxhi_in; ix++) + grid_fft[n++] = grid_brick[iz][iy][ix]; + + // remap FFT grid from brick to x pencil partitioning + + remap->perform(grid_fft,grid_fft,remap_buf); + + if (DEBUG) debug_scalar(FFT,"PRE Convo / POST Remap"); + if (DEBUG) debug_file(FFT,"pre.convo.post.remap"); + + // copy real values into complex grid + + n = 0; + for (int i = 0; i < nfft_owned; i++) { + cfft[n++] = grid_fft[i]; + cfft[n++] = ZEROF; + } + + // perform forward FFT + + fft1->compute(cfft,cfft,FFT3d::FORWARD); + + if (SCALE) { + double scale = 1.0/nfft_global; + for (int i = 0; i < 2*nfft_owned; i++) cfft[i] *= scale; + } + + if (DEBUG) debug_scalar(CFFT1,"PRE Convo / POST FFT"); + if (DEBUG) debug_file(CFFT1,"pre.convo.post.fft"); + + return cfft; +} + +/* ---------------------------------------------------------------------- + perform pre-convolution grid operations for 4d cgrid_brick array +------------------------------------------------------------------------- */ + +FFT_SCALAR *AmoebaConvolution::pre_convolution_4d() +{ + int ix,iy,iz,n; + + // reverse comm for 4d brick grid + ghosts + + if (DEBUG) debug_scalar(GRIDBRICK_OUT,"PRE Convo / PRE GridComm"); + + gc->reverse_comm(amoeba,2,sizeof(FFT_SCALAR),which, + gc_buf1,gc_buf2,MPI_FFT_SCALAR); + + if (DEBUG) debug_scalar(GRIDBRICK_IN,"PRE Convo / POST GridComm"); + if (DEBUG) debug_file(GRIDBRICK_IN,"pre.convo.post.gridcomm"); + + // copy owned 4d brick grid values to FFT grid + + n = 0; + for (iz = nzlo_in; iz <= nzhi_in; iz++) + for (iy = nylo_in; iy <= nyhi_in; iy++) + for (ix = nxlo_in; ix <= nxhi_in; ix++) { + cfft[n++] = cgrid_brick[iz][iy][ix][0]; + cfft[n++] = cgrid_brick[iz][iy][ix][1]; + } + + // remap FFT grid from brick to x pencil partitioning + // NOTE: could just setup FFT to start from brick decomp and skip remap + + remap->perform(cfft,cfft,remap_buf); + + if (DEBUG) debug_scalar(FFT,"PRE Convo / POST Remap"); + if (DEBUG) debug_file(FFT,"pre.convo.post.remap"); + + // perform forward FFT + + fft1->compute(cfft,cfft,FFT3d::FORWARD); + + if (SCALE) { + double scale = 1.0/nfft_global; + for (int i = 0; i < 2*nfft_owned; i++) cfft[i] *= scale; + } + + if (DEBUG) debug_scalar(CFFT1,"PRE Convo / POST FFT"); + if (DEBUG) debug_file(CFFT1,"pre.convo.post.fft"); + + return cfft; +} + +/* ---------------------------------------------------------------------- + perform post-convolution grid operations + can be 3d real or 4d complex array + return pointer to data in brick grid, caller casts to 3d or 4d +------------------------------------------------------------------------- */ + +void *AmoebaConvolution::post_convolution() +{ + if (flag3d) return post_convolution_3d(); + return post_convolution_4d(); +} + +/* ---------------------------------------------------------------------- + perform post-convolution grid operations for 3d grid_brick array +------------------------------------------------------------------------- */ + +void *AmoebaConvolution::post_convolution_3d() +{ + int ix,iy,iz,n; + + // perform backward FFT + + if (DEBUG) debug_scalar(CFFT1,"POST Convo / PRE FFT"); + if (DEBUG) debug_file(CFFT1,"post.convo.pre.fft"); + + fft2->compute(cfft,cfft,FFT3d::BACKWARD); + + if (DEBUG) debug_scalar(CFFT2,"POST Convo / POST FFT"); + if (DEBUG) debug_file(CFFT2,"post.convo.post.fft"); + + // copy real portion of 1d complex values into 3d real grid + + n = 0; + for (iz = nzlo_in; iz <= nzhi_in; iz++) + for (iy = nylo_in; iy <= nyhi_in; iy++) + for (ix = nxlo_in; ix <= nxhi_in; ix++) { + grid_brick[iz][iy][ix] = cfft[n]; + n += 2; + } + + // forward comm to populate ghost grid values + + if (DEBUG) debug_scalar(GRIDBRICK_IN,"POST Convo / PRE gridcomm"); + if (DEBUG) debug_file(GRIDBRICK_IN,"post.convo.pre.gridcomm"); + + gc->forward_comm(amoeba,1,sizeof(FFT_SCALAR),which, + gc_buf1,gc_buf2,MPI_FFT_SCALAR); + + return (void *) grid_brick; +} + +/* ---------------------------------------------------------------------- + perform post-convolution grid operations for 4d cgrid_brick array +------------------------------------------------------------------------- */ + +void *AmoebaConvolution::post_convolution_4d() +{ + int ix,iy,iz,n; + + // perform backward FFT + + if (DEBUG) debug_scalar(CFFT1,"POST Convo / PRE FFT"); + if (DEBUG) debug_file(CFFT1,"post.convo.pre.fft"); + + fft2->compute(cfft,cfft,FFT3d::BACKWARD); + + if (DEBUG) debug_scalar(CFFT2,"POST Convo / POST FFT"); + if (DEBUG) debug_file(CFFT2,"post.convo.post.fft"); + + // copy 1d complex values into 4d complex grid + + n = 0; + for (iz = nzlo_in; iz <= nzhi_in; iz++) + for (iy = nylo_in; iy <= nyhi_in; iy++) + for (ix = nxlo_in; ix <= nxhi_in; ix++) { + cgrid_brick[iz][iy][ix][0] = cfft[n++]; + cgrid_brick[iz][iy][ix][1] = cfft[n++]; + } + + // forward comm to populate ghost grid values + + if (DEBUG) debug_scalar(GRIDBRICK_IN,"POST Convo / PRE gridcomm"); + if (DEBUG) debug_file(GRIDBRICK_IN,"post.convo.pre.gridcomm"); + + gc->forward_comm(amoeba,2,sizeof(FFT_SCALAR),which, + gc_buf1,gc_buf2,MPI_FFT_SCALAR); + + return (void *) cgrid_brick; +} + +/* ---------------------------------------------------------------------- + convert a sphere in box coords to an ellipsoid in lamda (0-1) + coords and return the tight (axis-aligned) bounding box, does not + preserve vector magnitude + see http://www.loria.fr/~shornus/ellipsoid-bbox.html and + http://yiningkarlli.blogspot.com/2013/02/ + bounding-boxes-for-ellipsoidsfigure.html +------------------------------------------------------------------------- */ + +void AmoebaConvolution::kspacebbox(double r, double *b) +{ + double *h = domain->h; + double lx,ly,lz,xy,xz,yz; + + lx = h[0]; ly = h[1]; lz = h[2]; + yz = h[3]; xz = h[4]; xy = h[5]; + + b[0] = r*sqrt(ly*ly*lz*lz + ly*ly*xz*xz - 2.0*ly*xy*xz*yz + lz*lz*xy*xy + + xy*xy*yz*yz)/(lx*ly*lz); + b[1] = r*sqrt(lz*lz + yz*yz)/(ly*lz); + b[2] = r/lz; +} + +/* ---------------------------------------------------------------------- + map nprocs to NX by NY grid as PX by PY procs - return optimal px,py + copy of PPPM::procs2grid2d() +------------------------------------------------------------------------- */ + +void AmoebaConvolution::procs2grid2d(int nprocs, int nx, int ny, int &px, int &py) +{ + // loop thru all possible factorizations of nprocs + // surf = surface area of largest proc sub-domain + // innermost if test minimizes surface area and surface/volume ratio + + int bestsurf = 2 * (nx + ny); + int bestboxx = 0; + int bestboxy = 0; + + int boxx,boxy,surf,ipx,ipy; + + ipx = 1; + while (ipx <= nprocs) { + if (nprocs % ipx == 0) { + ipy = nprocs/ipx; + boxx = nx/ipx; + if (nx % ipx) boxx++; + boxy = ny/ipy; + if (ny % ipy) boxy++; + surf = boxx + boxy; + if (surf < bestsurf || + (surf == bestsurf && boxx*boxy > bestboxx*bestboxy)) { + bestsurf = surf; + bestboxx = boxx; + bestboxy = boxy; + px = ipx; + py = ipy; + } + } + ipx++; + } +} + +/* ---------------------------------------------------------------------- + output a scalar value to screen + array = which array is being summed over +---------------------------------------------------------------------- */ + +void AmoebaConvolution::debug_scalar(int array, const char *label) +{ + double sum = 0.0; + + if (array == GRIDBRICK_OUT) { + if (flag3d) { + for (int iz = nzlo_out; iz <= nzhi_out; iz++) + for (int iy = nylo_out; iy <= nyhi_out; iy++) + for (int ix = nxlo_out; ix <= nxhi_out; ix++) + sum += grid_brick[iz][iy][ix]; + } else { + for (int iz = nzlo_out; iz <= nzhi_out; iz++) + for (int iy = nylo_out; iy <= nyhi_out; iy++) + for (int ix = nxlo_out; ix <= nxhi_out; ix++) { + sum += cgrid_brick[iz][iy][ix][0]; + sum += cgrid_brick[iz][iy][ix][1]; + } + } + } + + if (array == GRIDBRICK_IN) { + if (flag3d) { + for (int iz = nzlo_in; iz <= nzhi_in; iz++) + for (int iy = nylo_in; iy <= nyhi_in; iy++) + for (int ix = nxlo_in; ix <= nxhi_in; ix++) + sum += grid_brick[iz][iy][ix]; + } else { + for (int iz = nzlo_in; iz <= nzhi_in; iz++) + for (int iy = nylo_in; iy <= nyhi_in; iy++) + for (int ix = nxlo_in; ix <= nxhi_in; ix++) { + sum += cgrid_brick[iz][iy][ix][0]; + sum += cgrid_brick[iz][iy][ix][1]; + } + } + } + + if (array == FFT) { + if (flag3d) { + for (int i = 0; i < nfft_owned; i++) + sum += grid_fft[i]; + } else { + for (int i = 0; i < 2*nfft_owned; i++) + sum += cfft[i]; + } + } + + if (array == CFFT1) { + for (int i = 0; i < 2*nfft_owned; i++) + sum += cfft[i]; + } + + if (array == CFFT2) { + for (int i = 0; i < 2*nbrick_owned; i++) + sum += cfft[i]; + } + + /* + double sumall; + MPI_Allreduce(&sum,&sumall,1,MPI_DOUBLE,MPI_SUM,world); + if (comm->me == 0) printf("%s: %s: %12.8g\n",labels[which],label,sumall); + */ +} + +/* ---------------------------------------------------------------------- + dump grid values to a file + array = which array is being output +---------------------------------------------------------------------- */ + +void AmoebaConvolution::debug_file(int array, const char *label) +{ + FILE *fp; + + int me = comm->me; + int nprocs = comm->nprocs; + + // open file + + char fname[128]; + sprintf(fname,"tmp.%s.%s",labels[which],label); + if (me == 0) fp = fopen(fname,"w"); + + // file header + // ncol = # of columns, including grid cell ID + + bigint ntot = nx * ny * nz; + + int ncol; + char *columns; + + if (array == CFFT1 || array == CFFT2 || !flag3d) { + ncol = 3; + columns = (char *) "id real imag"; + } else { + ncol = 2; + columns = (char *) "id value"; + } + + char boundstr[9]; // encoding of boundary flags + domain->boundary_string(boundstr); + + if (me == 0) { + fprintf(fp,"ITEM: TIMESTEP\n"); + fprintf(fp,BIGINT_FORMAT "\n",update->ntimestep); + fprintf(fp,"ITEM: NUMBER OF ATOMS\n"); + fprintf(fp,BIGINT_FORMAT "\n",ntot); + fprintf(fp,"ITEM: BOX BOUNDS %s\n",boundstr); + fprintf(fp,"%-1.16e %-1.16e\n",domain->boxlo[0],domain->boxhi[0]); + fprintf(fp,"%-1.16e %-1.16e\n",domain->boxlo[1],domain->boxhi[1]); + fprintf(fp,"%-1.16e %-1.16e\n",domain->boxlo[2],domain->boxhi[2]); + fprintf(fp,"ITEM: ATOMS %s\n",columns); + } + + // pack my values + // ngrid = # of grid cells I own + + int ngrid; + if (array == GRIDBRICK_IN) ngrid = nbrick_owned; + else if (array == FFT) ngrid = nfft_owned; + else if (array == CFFT1) ngrid = nfft_owned; + else if (array == CFFT2) ngrid = nbrick_owned; + + int ngridmax; + MPI_Allreduce(&ngrid,&ngridmax,1,MPI_INT,MPI_MAX,world); + + double *buf,*buf2; + memory->create(buf,ncol*ngridmax,"amoeba:buf"); + memory->create(buf2,ncol*ngridmax,"amoeba:buf2"); + + ngrid = 0; + + if (array == GRIDBRICK_IN) { + if (flag3d) { + for (int iz = nzlo_in; iz <= nzhi_in; iz++) + for (int iy = nylo_in; iy <= nyhi_in; iy++) + for (int ix = nxlo_in; ix <= nxhi_in; ix++) { + int id = iz*ny*nx + iy*nx + ix + 1; + buf[ncol*ngrid] = id; + buf[ncol*ngrid+1] = grid_brick[iz][iy][ix]; + ngrid++; + } + } else { + for (int iz = nzlo_in; iz <= nzhi_in; iz++) + for (int iy = nylo_in; iy <= nyhi_in; iy++) + for (int ix = nxlo_in; ix <= nxhi_in; ix++) { + int id = iz*ny*nx + iy*nx + ix + 1; + buf[ncol*ngrid] = id; + buf[ncol*ngrid+1] = cgrid_brick[iz][iy][ix][0]; + buf[ncol*ngrid+2] = cgrid_brick[iz][iy][ix][1]; + ngrid++; + } + } + } + + if (array == FFT) { + if (flag3d) { + int m = 0; + for (int iz = nzlo_fft; iz <= nzhi_fft; iz++) + for (int iy = nylo_fft; iy <= nyhi_fft; iy++) + for (int ix = nxlo_fft; ix <= nxhi_fft; ix++) { + int id = iz*ny*nx + iy*nx + ix + 1; + buf[ncol*ngrid] = id; + buf[ncol*ngrid+1] = grid_fft[m++]; + ngrid++; + } + } else { + int m = 0; + for (int iz = nzlo_fft; iz <= nzhi_fft; iz++) + for (int iy = nylo_fft; iy <= nyhi_fft; iy++) + for (int ix = nxlo_fft; ix <= nxhi_fft; ix++) { + int id = iz*ny*nx + iy*nx + ix + 1; + buf[ncol*ngrid] = id; + buf[ncol*ngrid+1] = cfft[m++]; + buf[ncol*ngrid+2] = cfft[m++]; + ngrid++; + } + } + } + + if (array == CFFT1) { + int m = 0; + for (int iz = nzlo_fft; iz <= nzhi_fft; iz++) + for (int iy = nylo_fft; iy <= nyhi_fft; iy++) + for (int ix = nxlo_fft; ix <= nxhi_fft; ix++) { + int id = iz*ny*nx + iy*nx + ix + 1; + buf[ncol*ngrid] = id; + buf[ncol*ngrid+1] = cfft[m++]; + buf[ncol*ngrid+2] = cfft[m++]; + ngrid++; + } + } + + if (array == CFFT2) { + int m = 0; + for (int iz = nzlo_in; iz <= nzhi_in; iz++) + for (int iy = nylo_in; iy <= nyhi_in; iy++) + for (int ix = nxlo_in; ix <= nxhi_in; ix++) { + int id = iz*ny*nx + iy*nx + ix + 1; + buf[ncol*ngrid] = id; + buf[ncol*ngrid+1] = cfft[m++]; + buf[ncol*ngrid+2] = cfft[m++]; + ngrid++; + } + } + + // proc 0 outputs values + // pings other procs, send/recv of their values + + int tmp,nlines; + MPI_Request request; + MPI_Status status; + + if (me == 0) { + for (int iproc = 0; iproc < nprocs; iproc++) { + if (iproc) { + MPI_Irecv(buf,ngridmax*ncol,MPI_DOUBLE,iproc,0,world,&request); + MPI_Send(&tmp,0,MPI_INT,me+iproc,0,world); + MPI_Wait(&request,&status); + MPI_Get_count(&status,MPI_DOUBLE,&nlines); + nlines /= ncol; + } else nlines = ngrid; + + int n = 0; + for (int m = 0; m < nlines; m++) { + if (ncol == 2) + fprintf(fp,"%d %12.8g\n",(int) buf[n],buf[n+1]); + else if (ncol == 3) + fprintf(fp,"%d %12.8g %12.8g\n",(int ) buf[n],buf[n+1],buf[n+2]); + n += ncol; + } + } + + } else { + MPI_Recv(&tmp,0,MPI_INT,0,0,world,MPI_STATUS_IGNORE); + MPI_Rsend(buf,ngrid*ncol,MPI_DOUBLE,0,0,world); + } + + // close file + + if (me == 0) fclose(fp); + + // clean up + + memory->destroy(buf); + memory->destroy(buf2); +} diff --git a/src/AMOEBA/amoeba_convolution.h b/src/AMOEBA/amoeba_convolution.h new file mode 100644 index 0000000000..4821a034be --- /dev/null +++ b/src/AMOEBA/amoeba_convolution.h @@ -0,0 +1,88 @@ +/* -*- c++ -*- ---------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#ifndef LMP_AMOEBA_CONVOLUTION_H +#define LMP_AMOEBA_CONVOLUTION_H + +#include "pointers.h" + +#ifdef FFT_SINGLE +typedef float FFT_SCALAR; +#define LMP_FFT_PREC "single" +#define MPI_FFT_SCALAR MPI_FLOAT +#else + +typedef double FFT_SCALAR; +#define LMP_FFT_PREC "double" +#define MPI_FFT_SCALAR MPI_DOUBLE +#endif + +namespace LAMMPS_NS { + +class AmoebaConvolution : protected Pointers { + public: + int nx,ny,nz; + int order; + int nfft_global; // nx * ny * nz + int nfft_owned; // owned grid points in FFT decomp + int nxlo_in,nxhi_in,nylo_in,nyhi_in,nzlo_in,nzhi_in; + int nxlo_out,nxhi_out,nylo_out,nyhi_out,nzlo_out,nzhi_out; + int nxlo_fft,nxhi_fft,nylo_fft,nyhi_fft,nzlo_fft,nzhi_fft; + double *grid_brick_start; // lower left corner of (c)grid_brick data + + AmoebaConvolution(class LAMMPS *, class Pair *, + int, int, int, int, int); + ~AmoebaConvolution(); + void *zero(); + FFT_SCALAR *pre_convolution(); + void *post_convolution(); + + private: + int which; // caller name for convolution being performed + int flag3d; // 1 if using 3d grid_brick, 0 for 4d cgrid_brick + int nbrick_owned; // owned grid points in brick decomp + int nbrick_ghosts; // owned + ghost brick grid points + int ngrid_either; // max of nbrick_owned or nfft_owned + + class Pair *amoeba; + class FFT3d *fft1,*fft2; + class GridComm *gc; + class Remap *remap; + + double ***grid_brick; // 3d real brick grid with ghosts + double ****cgrid_brick; // 4d complex brick grid with ghosts + + FFT_SCALAR *grid_fft; // 3d FFT grid as 1d vector + FFT_SCALAR *cfft; // 3d complex FFT grid as 1d vector + + double *gc_buf1,*gc_buf2; // buffers for GridComm + double *remap_buf; // buffer for Remap + + void *zero_3d(); + void *zero_4d(); + FFT_SCALAR *pre_convolution_3d(); + FFT_SCALAR *pre_convolution_4d(); + void *post_convolution_3d(); + void *post_convolution_4d(); + void kspacebbox(double, double *); + void procs2grid2d(int, int, int, int &, int &); + + // DEBUG + + void debug_scalar(int,const char *); + void debug_file(int,const char *); +}; + +} + +#endif diff --git a/src/AMOEBA/amoeba_dispersion.cpp b/src/AMOEBA/amoeba_dispersion.cpp new file mode 100644 index 0000000000..bf9b3be11a --- /dev/null +++ b/src/AMOEBA/amoeba_dispersion.cpp @@ -0,0 +1,424 @@ +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#include "pair_amoeba.h" +#include +#include "amoeba_convolution.h" +#include "atom.h" +#include "domain.h" +#include "neigh_list.h" +#include "fft3d_wrap.h" +#include "math_const.h" +#include "memory.h" + +using namespace LAMMPS_NS; +using namespace MathConst; + +enum{VDWL,REPULSE,QFER,DISP,MPOLE,POLAR,USOLV,DISP_LONG,MPOLE_LONG,POLAR_LONG}; + +/* ---------------------------------------------------------------------- + dispersion = Ewald dispersion + adapted from Tinker edisp1d() routine +------------------------------------------------------------------------- */ + +void PairAmoeba::dispersion() +{ + // set cutoffs, taper coeffs, and PME params + + if (use_dewald) choose(DISP_LONG); + else choose(DISP); + + // owned atoms + + int nlocal = atom->nlocal; + + // compute the real space portion of the Ewald summation + + if (rspace_flag) dispersion_real(); + + // compute the reciprocal space part of the Ewald summation + + if (kspace_flag) dispersion_kspace(); + + // compute the self-energy portion of the Ewald summation + + int itype,iclass; + double term; + + for (int i = 0; i < nlocal; i++) { + itype = amtype[i]; + iclass = amtype2class[itype]; + term = pow(aewald,6) / 12.0; + edisp += term*csix[iclass]*csix[iclass]; + } +} + +/* ---------------------------------------------------------------------- + dispersion_real = real-space portion of Ewald dispersion + adapted from Tinker edreal1d() routine +------------------------------------------------------------------------- */ + +void PairAmoeba::dispersion_real() +{ + int i,j,ii,jj,itype,jtype,iclass,jclass; + double xi,yi,zi; + double xr,yr,zr; + double e,de,fgrp; + double ci,ck; + double r,r2,r6,r7; + double ai,ai2; + double ak,ak2; + double di,di2,di3,di4,di5; + double dk,dk2,dk3; + double ti,ti2; + double tk,tk2; + double expi,expk; + double damp3,damp5; + double damp,ddamp; + double ralpha2,scale; + double expterm,term; + double expa,rterm; + double dedx,dedy,dedz; + double vxx,vyx,vzx; + double vyy,vzy,vzz; + double factor_disp; + + int inum,jnum; + int *ilist,*jlist,*numneigh,**firstneigh; + + // owned atoms + + double **x = atom->x; + int nlocal = atom->nlocal; + + // neigh list + + inum = list->inum; + ilist = list->ilist; + numneigh = list->numneigh; + firstneigh = list->firstneigh; + + // compute the real space portion of the Ewald summation + + for (ii = 0; ii < inum; ii++) { + i = ilist[ii]; + itype = amtype[i]; + iclass = amtype2class[itype]; + jlist = firstneigh[i]; + jnum = numneigh[i]; + + ci = csix[iclass]; + ai = adisp[iclass]; + xi = x[i][0]; + yi = x[i][1]; + zi = x[i][2]; + + // decide whether to compute the current interaction + + for (jj = 0; jj < jnum; jj++) { + j = jlist[jj]; + factor_disp = special_disp[sbmask15(j)]; + j &= NEIGHMASK15; + + xr = xi - x[j][0]; + yr = yi - x[j][1]; + zr = zi - x[j][2]; + r2 = xr*xr + yr*yr + zr*zr; + if (r2 > off2) continue; + + // compute the energy contribution for this interaction + + jtype = amtype[j]; + jclass = amtype2class[jtype]; + ck = csix[jclass]; + ak = adisp[jclass]; + + r6 = r2*r2*r2; + ralpha2 = r2 * aewald*aewald; + term = 1.0 + ralpha2 + 0.5*ralpha2*ralpha2; + expterm = exp(-ralpha2); + expa = expterm * term; + + // find the damping factor for the dispersion interaction + + r = sqrt(r2); + r7 = r6 * r; + di = ai * r; + di2 = di * di; + di3 = di * di2; + dk = ak * r; + expi = exp(-di); + expk = exp(-dk); + + if (ai != ak) { + ai2 = ai * ai; + ak2 = ak * ak; + dk2 = dk * dk; + dk3 = dk * dk2; + ti = ak2 / (ak2-ai2); + ti2 = ti * ti; + tk = ai2 / (ai2-ak2); + tk2 = tk * tk; + damp3 = 1.0 - ti2*(1.0+di+0.5*di2)*expi - tk2*(1.0+dk+0.5*dk2)*expk - + 2.0*ti2*tk*(1.0+di)*expi - 2.0*tk2*ti*(1.0+dk)*expk; + damp5 = 1.0 - ti2*(1.0+di+0.5*di2+di3/6.0)*expi - + tk2*(1.0+dk+0.5*dk2 + dk3/6.0)*expk - + 2.0*ti2*tk*(1.0+di+di2/3.0)*expi - 2.0*tk2*ti*(1.0+dk+dk2/3.0)*expk; + ddamp = 0.25 * di2 * ti2 * ai * expi * (r*ai+4.0*tk-1.0) + + 0.25 * dk2 * tk2 * ak * expk * (r*ak+4.0*ti-1.0); + + } else { + di4 = di2 * di2; + di5 = di2 * di3; + damp3 = 1.0 - (1.0+di+0.5*di2 + 7.0*di3/48.0+di4/48.0)*expi; + damp5 = 1.0 - (1.0+di+0.5*di2 + di3/6.0+di4/24.0+di5/144.0)*expi; + ddamp = ai * expi * (di5-3.0*di3-3.0*di2) / 96.0; + } + + damp = 1.5*damp5 - 0.5*damp3; + + // apply damping and scaling factors for this interaction + + scale = factor_disp * damp*damp; + scale = scale - 1.0; + e = -ci * ck * (expa+scale) / r6; + rterm = -pow(ralpha2,3) * expterm / r; + de = -6.0*e/r2 - ci*ck*rterm/r7 - 2.0*ci*ck*factor_disp*damp*ddamp/r7; + + edisp += e; + + // increment the damped dispersion derivative components + + dedx = de * xr; + dedy = de * yr; + dedz = de * zr; + fdisp[i][0] += dedx; + fdisp[i][1] += dedy; + fdisp[i][2] += dedz; + fdisp[j][0] -= dedx; + fdisp[j][1] -= dedy; + fdisp[j][2] -= dedz; + + // increment the internal virial tensor components + + vxx = xr * dedx; + vyx = yr * dedx; + vzx = zr * dedx; + vyy = yr * dedy; + vzy = zr * dedy; + vzz = zr * dedz; + + virdisp[0] += vxx; + virdisp[1] += vyy; + virdisp[2] += vzz; + virdisp[3] += vyx; + virdisp[4] += vzx; + virdisp[5] += vzy; + + // energy = e + // virial = 6-vec vir + // NOTE: add tally function + + if (evflag) { + } + } + } +} + +/* ---------------------------------------------------------------------- + dispersion_kspace = KSpace portion of Ewald dispersion + adapted from Tinker edrecip1d() routine +------------------------------------------------------------------------- */ + +void PairAmoeba::dispersion_kspace() +{ + int i,j,k,m,n,ix,iy,iz,ib,jb,kb,itype,iclass; + int nhalf1,nhalf2,nhalf3; + int nxlo,nxhi,nylo,nyhi,nzlo,nzhi; + int i0,iatm,igrd0; + int it1,it2,it3; + int j0,jgrd0; + int k0,kgrd0; + double e,fi,denom; + double r1,r2,r3; + double h1,h2,h3; + double term,vterm; + double expterm; + double erfcterm; + double hsq,struc2; + double h,hhh,b,bfac; + double term1,denom0; + double fac1,fac2,fac3; + double de1,de2,de3; + double dt1,dt2,dt3; + double t1,t2,t3; + + // return if the Ewald coefficient is zero + + if (aewald < 1.0e-6) return; + + // owned atoms + + double **x = atom->x; + int nlocal = atom->nlocal; + + double volbox = domain->prd[0] * domain->prd[1] * domain->prd[2]; + + // FFT moduli pre-computations + // set igrid for each atom and its B-spline coeffs + + nfft1 = d_kspace->nx; + nfft2 = d_kspace->ny; + nfft3 = d_kspace->nz; + bsorder = d_kspace->order; + + moduli(); + bspline_fill(); + + // gridpre = my portion of 3d grid in brick decomp w/ ghost values + // zeroed by zero() + + double ***gridpre = (double ***) d_kspace->zero(); + + // map atoms to grid + + grid_disp(gridpre); + + // pre-convolution operations including forward FFT + // gridfft = my portion of complex 3d grid in FFT decomposition + + double *gridfft = d_kspace->pre_convolution(); + + // --------------------- + // convolution operation + // --------------------- + + nhalf1 = (nfft1+1) / 2; + nhalf2 = (nfft2+1) / 2; + nhalf3 = (nfft3+1) / 2; + + nxlo = d_kspace->nxlo_fft; + nxhi = d_kspace->nxhi_fft; + nylo = d_kspace->nylo_fft; + nyhi = d_kspace->nyhi_fft; + nzlo = d_kspace->nzlo_fft; + nzhi = d_kspace->nzhi_fft; + + bfac = MY_PI / aewald; + fac1 = 2.0*pow(MY_PI,3.5); + fac2 = pow(aewald,3.0); + fac3 = -2.0*aewald*MY_PI*MY_PI; + denom0 = (6.0*volbox)/pow(MY_PI,1.5); + + //qgrid[0][0][0][0] = 0.0; // NOTE: why is this needed? + //qgrid[0][0][0][1] = 0.0; + + n = 0; + for (k = nzlo; k <= nzhi; k++) { + for (j = nylo; j <= nyhi; j++) { + for (i = nxlo; i <= nxhi; i++) { + r1 = (i >= nhalf1) ? i-nfft1 : i; + r2 = (j >= nhalf2) ? j-nfft2 : j; + r3 = (k >= nhalf3) ? k-nfft3 : k; + h1 = recip[0][0]*r1 + recip[0][1]*r2 + recip[0][2]*r3; // matvec + h2 = recip[1][0]*r1 + recip[1][1]*r2 + recip[1][2]*r3; + h3 = recip[2][0]*r1 + recip[2][1]*r2 + recip[2][2]*r3; + hsq = h1*h1 + h2*h2 + h3*h3; + h = sqrt(hsq); + b = h*bfac; + hhh = h*hsq; + term = -b*b; + expterm = 0.0; + erfcterm = erfc(b); + denom = denom0*bsmod1[i]*bsmod2[j]*bsmod3[k]; + if (term > -50.0 && hsq != 0.0) { + expterm = exp(term); + erfcterm = erfc(b); + term1 = fac1*erfcterm*hhh + expterm*(fac2 + fac3*hsq); + struc2 = gridfft[n]*gridfft[n] + gridfft[n+1]*gridfft[n+1]; + e = -(term1 / denom) * struc2; + edisp += e; + vterm = 3.0 * (fac1*erfcterm*h + fac3*expterm) * struc2/denom; + virdisp[0] += h1*h1*vterm - e; + virdisp[1] += h2*h2*vterm - e; + virdisp[2] += h3*h3*vterm - e; + virdisp[3] += h1*h2*vterm; + virdisp[4] += h1*h3*vterm; + virdisp[5] += h2*h3*vterm; + } else term1 = 0.0; + // NOTE: pre-calc this division only once + gridfft[n] *= -(term1/denom); + gridfft[n+1] *= -(term1/denom); + n += 2; + } + } + } + + // post-convolution operations including backward FFT + // gridppost = my portion of 3d grid in brick decomp w/ ghost values + + double ***gridpost = (double ***) d_kspace->post_convolution(); + + // get first derivatives of the reciprocal space energy + + int nlpts = (bsorder-1) / 2; + int nrpts = bsorder - nlpts - 1; + + for (m = 0; m < nlocal; m++) { + itype = amtype[m]; + iclass = amtype2class[itype]; + de1 = de2 = de3 = 0.0; + + k = igrid[m][2] - nlpts; + for (kb = 0; kb < bsorder; kb++) { + t3 = thetai3[m][kb][0]; + dt3 = nfft3 * thetai3[m][kb][1]; + + j = igrid[m][1] - nlpts; + for (jb = 0; jb < bsorder; jb++) { + t2 = thetai2[m][jb][0]; + dt2 = nfft2 * thetai2[m][jb][1]; + + i = igrid[m][0] - nlpts; + for (ib = 0; ib < bsorder; ib++) { + t1 = thetai1[m][ib][0]; + dt1 = nfft1 * thetai1[m][ib][1]; + term = gridpost[k][j][i]; + de1 += 2.0*term*dt1*t2*t3; + de2 += 2.0*term*dt2*t1*t3; + de3 += 2.0*term*dt3*t1*t2; + i++; + } + j++; + } + k++; + } + + fi = csix[iclass]; + fdisp[m][0] += fi * (recip[0][0]*de1 + recip[0][1]*de2 + recip[0][2]*de3); + fdisp[m][1] += fi * (recip[1][0]*de1 + recip[1][1]*de2 + recip[1][2]*de3); + fdisp[m][2] += fi * (recip[2][0]*de1 + recip[2][1]*de2 + recip[2][2]*de3); + } + + // account for the energy and virial correction terms + + term = csixpr * aewald*aewald*aewald / denom0; + + + if (me == 0) { + edisp -= term; + virdisp[0] += term; + virdisp[1] += term; + virdisp[2] += term; + } +} diff --git a/src/AMOEBA/amoeba_file.cpp b/src/AMOEBA/amoeba_file.cpp new file mode 100644 index 0000000000..2469c08f43 --- /dev/null +++ b/src/AMOEBA/amoeba_file.cpp @@ -0,0 +1,1381 @@ +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel ator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#include "pair_amoeba.h" +#include +#include +#include +#include +#include "domain.h" +#include "comm.h" +#include "force.h" +#include "memory.h" +#include "error.h" +#include "utils.h" + +using namespace LAMMPS_NS; + +enum{FFIELD,LITERATURE,ATOMTYPE,VDWL,VDWLPAIR,BSTRETCH,SBEND,ABEND, + PAULI,DISPERSION,UB,OUTPLANE,TORSION,PITORSION,ATOMMULT, + QPENETRATION,DIPPOLAR,QTRANSFER,UNKNOWN}; +enum{ALLINGER,BUFFERED_14_7}; +enum{ARITHMETIC,GEOMETRIC,CUBIC_MEAN,R_MIN,SIGMA,DIAMETER,HARMONIC,HHG,W_H}; +enum{MUTUAL,OPT,TCG,DIRECT}; +enum{NOFRAME,ZONLY,ZTHENX,BISECTOR,ZBISECT,THREEFOLD}; +enum{GEAR,ASPC,LSQR}; + +#define MAXLINE 65536 // crazy big for TORSION-TORSION section +#define MAX_TYPE_PER_GROUP 6 // max types per AMOEBA group +#define MAX_FRAME_PER_TYPE 32 // max multipole frames for any AMOEBA type + +#define DELTA_TYPE_CLASS 32 +#define DELTA_VDWL_PAIR 16 + +#define BOHR 0.52917721067 // Bohr in Angstroms + +// methods to read, parse, and store info from force field file + +/* ---------------------------------------------------------------------- + set default values for items read from PRM and key files +------------------------------------------------------------------------- */ + +void PairAmoeba::set_defaults() +{ + for (int i = 0; i <= 4; i++) { + special_hal[i] = 1.0; + special_repel[i] = 1.0; + special_disp[i] = 1.0; + special_mpole[i] = 1.0; + special_polar_pscale[i] = 1.0; + special_polar_piscale[i] = 1.0; + special_polar_wscale[i] = 1.0; + } + + polar_dscale = 0.0; + polar_uscale = 0.0; +} + +/* ---------------------------------------------------------------------- + read PRM force field file +------------------------------------------------------------------------- */ + +void PairAmoeba::read_prmfile(char *filename) +{ + int n,nextflag; + + // open potential file + + int me = comm->me; + FILE *fptr; + char line[MAXLINE],next[MAXLINE]; + + if (me == 0) { + fptr = utils::open_potential(filename,lmp,nullptr); + if (fptr == NULL) { + char str[128]; + snprintf(str,128,"Cannot open AMOEBA PRM file %s",filename); + error->one(FLERR,str); + } + } + + // read sections, one at a time + // Force Field Definition section must come first + // skip Literature References section + // Atom Type Definitions must come before any other section + // other sections can follow in any order + + // NOTE: don't use tokenize when not needed, doc string methods better + // NOTE: how to insure each section had enough lines? + + int forcefield_flag = 0; + int atomtype_flag = 0; + int section; + + while (1) { + if (me == 0) n = read_section_name(fptr,line); + MPI_Bcast(&n,1,MPI_INT,0,world); + if (n < 0) break; + MPI_Bcast(line,n+1,MPI_CHAR,0,world); + + //printf("Section: %s\n",line); + + if (strstr(line,"Force Field") == line) section = FFIELD; + else if (strstr(line,"Literature") == line) section = LITERATURE; + else if (strstr(line,"Atom Type") == line) section = ATOMTYPE; + else if (strstr(line,"Van der Waals Param") == line) section = VDWL; + else if (strstr(line,"Van der Waals Pair") == line) section = VDWLPAIR; + else if (strstr(line,"Bond Stretching") == line) section = BSTRETCH; + else if (strstr(line,"Stretch-Bend") == line) section = SBEND; + else if (strstr(line,"Angle Bending") == line) section = ABEND; + else if (strstr(line,"Pauli Repulsion") == line) section = PAULI; + else if (strstr(line,"Dispersion Param") == line) section = DISPERSION; + else if (strstr(line,"Urey-Bradley") == line) section = UB; + else if (strstr(line,"Out-of-Plane") == line) section = OUTPLANE; + else if (strstr(line,"Torsional") == line) section = TORSION; + else if (strstr(line,"Pi-Torsion") == line) section = PITORSION; + else if (strstr(line,"Atomic Multipole") == line) section = ATOMMULT; + else if (strstr(line,"Charge Penetration") == line) section = QPENETRATION; + else if (strstr(line,"Dipole Polarizability") == line) section = DIPPOLAR; + else if (strstr(line,"Charge Transfer") == line) section = QTRANSFER; + else { + if (me == 0) printf("Skipping section: %s\n",line); + section = UNKNOWN; + } + + if (forcefield_flag == 0 && section != FFIELD) + error->all(FLERR,"Force Field is not first section of " + "pair amoeba potential file"); + if (section != FFIELD && section != LITERATURE && section != ATOMTYPE && + section != UNKNOWN && atomtype_flag == 0) + error->all(FLERR,"Atom Type section of pair amoeba potential file " + "must come before all but Force Field section"); + + if (section == FFIELD) forcefield_flag = 1; + if (section == ATOMTYPE) atomtype_flag = 1; + + if (section == ATOMMULT) { + for (int i = 1; i <= n_amtype; i++) nmultiframe[i] = 0; + } + + nextflag = 0; + + while (1) { + if (me == 0) n = read_section_line(fptr,line,nextflag,next); + MPI_Bcast(&n,1,MPI_INT,0,world); + if (n < 0) break; + MPI_Bcast(line,n+1,MPI_CHAR,0,world); + if (n == 0) break; // line starting with #### = next section line + + // convert all chars in line to lower-case + + for (int i = 0; i < n; i++) + line[i] = tolower(line[i]); + + char *copy; + char **words; + int nwords = tokenize(line,words,copy); + + if (section == FFIELD) file_ffield(nwords,words); + else if (section == LITERATURE) file_literature(nwords,words); + else if (section == ATOMTYPE) file_atomtype(nwords,words); + else if (section == VDWL) file_vdwl(nwords,words); + else if (section == VDWLPAIR) file_vdwl_pair(nwords,words); + else if (section == BSTRETCH) file_bstretch(nwords,words); + else if (section == SBEND) file_sbend(nwords,words); + else if (section == ABEND) file_abend(nwords,words); + else if (section == PAULI) file_pauli(nwords,words); + else if (section == DISPERSION) file_dispersion(nwords,words); + else if (section == UB) file_ub(nwords,words); + else if (section == OUTPLANE) file_outplane(nwords,words); + else if (section == TORSION) file_torsion(nwords,words); + else if (section == PITORSION) file_pitorsion(nwords,words); + else if (section == ATOMMULT) file_multipole(nwords,words); + else if (section == QPENETRATION) file_charge_penetration(nwords,words); + else if (section == DIPPOLAR) file_dippolar(nwords,words); + else if (section == QTRANSFER) file_charge_transfer(nwords,words); + else if (section == UNKNOWN) {} + + delete [] copy; + delete [] words; + } + + if (n < 0) break; + } + + if (me == 0) fclose(fptr); + + if (forcefield_flag == 0 || atomtype_flag == 0) + error->all(FLERR,"Pair amoeba potential file incomplete"); +} + +/* ---------------------------------------------------------------------- + read optional KEY file of one-line settings +------------------------------------------------------------------------- */ + +void PairAmoeba::read_keyfile(char *filename) +{ + double aprd,bprd,cprd; + + // default settings for which there are keyword options + + aprd = bprd = cprd = 0.0; + + vdwcut = 9.0; + vdwtaper = 0.9 * vdwcut; + repcut = 6.0; + reptaper = 0.9 * repcut; + dispcut = 9.0; + disptaper = 0.9 * dispcut; + mpolecut = 9.0; + mpoletaper = 0.65 * mpolecut; + ctrncut = 6.0; + ctrntaper = 0.9 * ctrncut; + + ewaldcut = 7.0; + dewaldcut = 7.0; + usolvcut = 4.5; + udiag = 2.0; + + dhal = 0.07; + ghal = 0.12; + + use_ewald = use_dewald = 0; + + bseorder = 5; + bsporder = 5; + bsdorder = 4; + + aeewald = 0.4; + apewald = 0.4; + adewald = 0.4; + + use_pred = 0; + polpred = LSQR; + politer = 100; + poleps = 1.0e-6; + + pcgprec = 1; + pcgpeek = 1.0; + pcgguess = 1; + + aeewald_key = apewald_key = adewald_key = 0; + pmegrid_key = dpmegrid_key = 0; + + // done if keyfile not specified by pair_coeff command + + if (!filename) return; + + // open key file + + int me = comm->me; + FILE *fptr; + char line[MAXLINE],next[MAXLINE]; + if (me == 0) { + fptr = utils::open_potential(filename,lmp,nullptr); + if (fptr == NULL) { + char str[128]; + snprintf(str,128,"Cannot open AMOEBA key file %s",filename); + error->one(FLERR,str); + } + } + + // read lines, one at a time + + int n; + char *ptr,*keyword; + + while (1) { + if (me == 0) { + ptr = fgets(line,MAXLINE,fptr); + if (!ptr) n = -1; + else n = strlen(line); + } + MPI_Bcast(&n,1,MPI_INT,0,world); + if (n < 0) break; + MPI_Bcast(line,n+1,MPI_CHAR,0,world); + if (strspn(line," \t\n\r") == strlen(line)) continue; + + // convert all chars in line to lower-case + + for (int i = 0; i < n; i++) + line[i] = tolower(line[i]); + + char *copy; + char **words; + int nwords = tokenize(line,words,copy); + keyword = words[0]; + + if (strstr(keyword,"#") || strstr(keyword,"!!") || !isalpha(keyword[0])) { + + } else if (strcmp(keyword,"a-axis") == 0) { + if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); + aprd = utils::numeric(FLERR,words[1],true,lmp); + } else if (strcmp(keyword,"b-axis") == 0) { + if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); + bprd = utils::numeric(FLERR,words[1],true,lmp); + } else if (strcmp(keyword,"c-axis") == 0) { + if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); + cprd = utils::numeric(FLERR,words[1],true,lmp); + + } else if (strcmp(keyword,"cutoff") == 0) { + if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); + double cut = utils::numeric(FLERR,words[1],true,lmp); + vdwcut = repcut = dispcut = mpolecut = ctrncut = ewaldcut = dewaldcut = cut; + vdwtaper = 0.9 * vdwcut; + reptaper = 0.9 * repcut; + disptaper = 0.9 * dispcut; + mpoletaper = 0.65 * mpolecut; + ctrntaper = 0.9 * ctrncut; + } else if (strcmp(keyword,"taper") == 0) { + if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); + double taper = utils::numeric(FLERR,words[1],true,lmp); + if (taper >= 1.0) { + vdwtaper = reptaper = disptaper = mpoletaper = ctrntaper = taper; + } else { + taper = -taper; + vdwtaper = taper * vdwcut; + reptaper = taper * repcut; + disptaper = taper * dispcut; + mpoletaper = taper * mpolecut; + ctrntaper = taper * ctrncut; + } + } else if (strcmp(keyword,"vdw-cutoff") == 0) { + if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); + vdwcut = utils::numeric(FLERR,words[1],true,lmp); + vdwtaper = 0.9 * vdwcut; + } else if (strcmp(keyword,"repulsion-cutoff") == 0) { + if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); + repcut = utils::numeric(FLERR,words[1],true,lmp); + reptaper = 0.9 * repcut; + } else if (strcmp(keyword,"dispersion-cutoff") == 0) { + if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); + dispcut = utils::numeric(FLERR,words[1],true,lmp); + disptaper = 0.9 * dispcut; + } else if (strcmp(keyword,"mpole-cutoff") == 0) { + if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); + mpolecut = utils::numeric(FLERR,words[1],true,lmp); + mpoletaper = 0.65 * mpolecut; + } else if (strcmp(keyword,"ctrn-cutoff") == 0) { + if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); + ctrncut = utils::numeric(FLERR,words[1],true,lmp); + ctrntaper = 0.9 * ctrncut; + } else if (strcmp(keyword,"ewald-cutoff") == 0) { + if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); + ewaldcut = utils::numeric(FLERR,words[1],true,lmp); + } else if (strcmp(keyword,"dewald-cutoff") == 0) { + if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); + dewaldcut = utils::numeric(FLERR,words[1],true,lmp); + } else if (strcmp(keyword,"usolve-cutoff") == 0) { + if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); + usolvcut = utils::numeric(FLERR,words[1],true,lmp); + } else if (strcmp(keyword,"usolve-diag") == 0) { + if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); + udiag = utils::numeric(FLERR,words[1],true,lmp); + + } else if (strcmp(keyword,"vdw-taper") == 0) { + if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); + vdwtaper = utils::numeric(FLERR,words[1],true,lmp); + if (vdwtaper < 1.0) vdwtaper = -vdwtaper * vdwcut; + } else if (strcmp(keyword,"repulsion-taper") == 0) { + if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); + reptaper = utils::numeric(FLERR,words[1],true,lmp); + if (reptaper < 1.0) reptaper = -reptaper * repcut; + } else if (strcmp(keyword,"dispersion-taper") == 0) { + if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); + disptaper = utils::numeric(FLERR,words[1],true,lmp); + if (disptaper < 1.0) disptaper = -disptaper * vdwcut; + } else if (strcmp(keyword,"mpole-taper") == 0) { + if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); + mpoletaper = utils::numeric(FLERR,words[1],true,lmp); + if (mpoletaper < 1.0) mpoletaper = -mpoletaper * vdwcut; + } else if (strcmp(keyword,"ctrn-taper") == 0) { + if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); + ctrntaper = utils::numeric(FLERR,words[1],true,lmp); + if (ctrntaper < 1.0) ctrntaper = -ctrntaper * vdwcut; + + } else if (strcmp(keyword,"delta-halgren") == 0) { + if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); + dhal = utils::numeric(FLERR,words[1],true,lmp); + } else if (strcmp(keyword,"gamma-halgren") == 0) { + if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); + ghal = utils::numeric(FLERR,words[1],true,lmp); + + } else if (strcmp(keyword,"ewald") == 0) { + if (nwords != 1) error->all(FLERR,"AMOEBA keyfile line is invalid"); + use_ewald = 1; + } else if (strcmp(keyword,"dewald") == 0) { + if (nwords != 1) error->all(FLERR,"AMOEBA keyfile line is invalid"); + use_dewald = 1; + + } else if (strcmp(keyword,"pme-order") == 0) { + if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); + bseorder = utils::numeric(FLERR,words[1],true,lmp); + } else if (strcmp(keyword,"ppme-order") == 0) { + if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); + bsporder = utils::numeric(FLERR,words[1],true,lmp); + } else if (strcmp(keyword,"dpme-order") == 0) { + if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); + bsdorder = utils::numeric(FLERR,words[1],true,lmp); + + } else if (strcmp(keyword,"pme-grid") == 0) { + if (nwords != 2 && nwords != 4) + error->all(FLERR,"AMOEBA keyfile line is invalid"); + if (nwords == 2) + nefft1 = nefft2 = nefft3 = utils::numeric(FLERR,words[1],true,lmp); + else { + nefft1 = utils::numeric(FLERR,words[1],true,lmp); + nefft2 = utils::numeric(FLERR,words[2],true,lmp); + nefft3 = utils::numeric(FLERR,words[3],true,lmp); + } + pmegrid_key = 1; + } else if (strcmp(keyword,"dpme-grid") == 0) { + if (nwords != 2 && nwords != 4) + error->all(FLERR,"AMOEBA keyfile line is invalid"); + if (nwords == 2) + ndfft1 = ndfft2 = ndfft3 = utils::numeric(FLERR,words[1],true,lmp); + else { + ndfft1 = utils::numeric(FLERR,words[1],true,lmp); + ndfft2 = utils::numeric(FLERR,words[2],true,lmp); + ndfft3 = utils::numeric(FLERR,words[3],true,lmp); + } + dpmegrid_key = 1; + + } else if (strcmp(keyword,"ewald-alpha") == 0) { + if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); + aeewald = utils::numeric(FLERR,words[1],true,lmp); + aeewald_key = 1; + } else if (strcmp(keyword,"pewald-alpha") == 0) { + if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); + apewald = utils::numeric(FLERR,words[1],true,lmp); + apewald_key = 1; + } else if (strcmp(keyword,"dewald-alpha") == 0) { + if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); + adewald = utils::numeric(FLERR,words[1],true,lmp); + adewald_key = 1; + + // polarization options + + } else if (strcmp(words[0],"polarization") == 0) { + if (strcmp(words[1],"mutual") == 0) poltyp = MUTUAL; + else if (strstr(words[1],"opt") == words[1]) { + poltyp = OPT; + if (strcmp(words[1],"opt") == 0) optorder = 4; + else optorder = utils::inumeric(FLERR,&words[1][3],true,lmp); + if (optorder < 1 || optorder > 6) + error->all(FLERR,"Unrecognized polarization OPTn in AMOEBA FF file"); + } else if (strcmp(words[1],"tcg") == 0) + error->all(FLERR,"Polarization TCG not yet supported in AMOEBA/HIPPO"); + else if (strcmp(words[1],"direct") == 0) poltyp = DIRECT; + else error->all(FLERR,"Unrecognized polarization in AMOEBA FF file"); + + } else if (strcmp(keyword,"polar-predict") == 0) { + if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); + if (strcmp(words[1],"gear") == 0) { + polpred = GEAR; + maxualt = 7; + } else if (strcmp(words[1],"aspc") == 0) { + polpred = ASPC; + maxualt = 17; + } else if (strcmp(words[1],"lsqr") == 0) { + polpred = LSQR; + maxualt = 7; + } else error->all(FLERR,"AMOEBA keyfile line is invalid"); + use_pred = 1; + } else if (strcmp(keyword,"polar-iter") == 0) { + if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); + politer = utils::inumeric(FLERR,words[1],true,lmp); + } else if (strcmp(keyword,"polar-eps") == 0) { + if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); + poleps = utils::numeric(FLERR,words[1],true,lmp); + + } else if (strcmp(keyword,"pcg-precond") == 0) { + if (nwords != 1) error->all(FLERR,"AMOEBA keyfile line is invalid"); + pcgprec = 1; + } else if (strcmp(keyword,"pcg-noprecond") == 0) { + if (nwords != 1) error->all(FLERR,"AMOEBA keyfile line is invalid"); + pcgprec = 0; + } else if (strcmp(keyword,"pcg-guess") == 0) { + if (nwords != 1) error->all(FLERR,"AMOEBA keyfile line is invalid"); + pcgguess = 1; + } else if (strcmp(keyword,"pcg-noguess") == 0) { + if (nwords != 1) error->all(FLERR,"AMOEBA keyfile line is invalid"); + pcgguess = 0; + } else if (strcmp(keyword,"pcg-peek") == 0) { + if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); + pcgpeek = utils::numeric(FLERR,words[1],true,lmp); + } else if (strcmp(keyword,"usolve-diag") == 0) { + if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); + udiag = utils::numeric(FLERR,words[1],true,lmp); + + } else {} + + delete [] copy; + delete [] words; + } + + // close key file + + if (me == 0) fclose(fptr); + + // cutoff resets for long-range interactions + + if (use_ewald) mpolecut = ewaldcut; + if (use_dewald) dispcut = dewaldcut; + + // error checks + + if (use_ewald || use_dewald) { + if (domain->nonperiodic) + error->all(FLERR,"AMOEBA KSpace requires fully periodic system"); + } + + if (aprd > 0.0 && (!domain->xperiodic || domain->xprd != aprd)) + error->all(FLERR,"AMOEBA abc prd does not match LAMMPS domain"); + if (bprd > 0.0 && (!domain->yperiodic || domain->yprd != bprd)) + error->all(FLERR,"AMOEBA abc prd does not match LAMMPS domain"); + if (cprd > 0.0 && (!domain->zperiodic || domain->zprd != cprd)) + error->all(FLERR,"AMOEBA abc prd does not match LAMMPS domain"); +} + +/* ---------------------------------------------------------------------- */ + +int PairAmoeba::read_section_name(FILE *fp, char *line) +{ + char dummy[MAXLINE]; + + // loop on read line + // return -1 if EOF + // skip line if blank + // tokenize + // if ncount <= 2 skip line + // if 1st word and last word != ## then error + // pack line with 2nd thru next-to-last words + // return length of line + + char *ptr,*copy; + char **words; + int nwords; + + while (1) { + ptr = fgets(line,MAXLINE,fp); + if (!ptr) return -1; + if (strspn(line," \t\n\r") == strlen(line)) continue; + nwords = tokenize(line,words,copy); + if (nwords <= 2) { + delete [] copy; + delete [] words; + continue; + } + break; + } + + if ((strstr(words[0],"##") != words[0]) || + (strstr(words[nwords-1],"##") != words[nwords-1])) + error->one(FLERR,"Section header of pair amoeba potential file is invalid"); + + line[0] = '\0'; + for (int i = 1; i < nwords-1; i++) { + if (i > 1) strcat(line," "); + strcat(line,words[i]); + } + int n = strlen(line); + + delete [] copy; + delete [] words; + + // skip next 2 lines of section header + + fgets(dummy,MAXLINE,fp); + fgets(dummy,MAXLINE,fp); + + return n; +} + +/* ---------------------------------------------------------------------- */ + +int PairAmoeba::read_section_line(FILE *fp, char *line, + int &nextflag, char *next) +{ + // loop on read line + // if next line defined, use it instead of read + // return -1 if EOF + // skip line if blank + // tokenize + // if first word starts with ####, return 0 + // if first word starts with # or !!, continue + // append continuation lines to line + // until a line is blank, starts with #, starts with alpha char, or EOF + // save next line read, and set nextflag for next call + // return length of line + + char *ptr,*copy,*copy_next; + char **words,**words_next; + int nwords,nwords_next; + + copy = copy_next = NULL; + words = words_next = NULL; + + while (1) { + if (nextflag) { + strcpy(line,next); + nextflag = 0; + } else { + ptr = fgets(line,MAXLINE,fp); + if (!ptr) return -1; + } + + if (strspn(line," \t\n\r") == strlen(line)) continue; + nwords = tokenize(line,words,copy); + if (strstr(words[0],"####")) { + delete [] words; + delete [] copy; + return 0; + } + if (strstr(words[0],"#") || strstr(words[0],"!!") || !isalpha(words[0][0])) { + delete [] words; + delete [] copy; + words = NULL; + copy = NULL; + continue; + } + while (1) { + ptr = fgets(next,MAXLINE,fp); + if (!ptr) { + nextflag = 0; + delete [] words; + delete [] copy; + return strlen(line); + } + nwords_next = tokenize(next,words_next,copy_next); + if (nwords_next == 0) break; + if (words_next[0][0] == '#') break; + if (isalpha(words_next[0][0])) break; + strcat(line,next); + delete [] words_next; + delete [] copy_next; + } + nextflag = 1; + break; + } + + delete [] copy; + delete [] words; + delete [] copy_next; + delete [] words_next; + + int n = strlen(line); + return n; +} + +/* ---------------------------------------------------------------------- + tokenize str into white-space separated words + return nwords = number of words + return words = vector of ptrs to each word + also return copystr since words points into it + if a word is !!, that word and the rest of the line is discarded + IMPORTANT: caller must delete words and copystr +------------------------------------------------------------------------- */ + +int PairAmoeba::tokenize(char *str, char **&words, char *©str) +{ + int n = strlen(str) + 1; + copystr = new char[n]; + strcpy(copystr,str); + + int nword = count_words(copystr); + words = new char*[nword]; + + nword = 0; + char *word = strtok(copystr," \t\n\r\f"); + while (word) { + words[nword++] = word; + word = strtok(NULL," \t\n\r\f"); + if (word && strcmp(word,"!!") == 0) break; + } + + return nword; +} + +/* ---------------------------------------------------------------------- + count and return words in a single line + make copy of line before using strtok so as not to change line +------------------------------------------------------------------------- */ + +int PairAmoeba::count_words(const char *line) +{ + int n = strlen(line) + 1; + char *copy = new char[n]; + strcpy(copy,line); + + if (strtok(copy," \t\n\r\f") == NULL) { + delete [] copy; + return 0; + } + n = 1; + while (strtok(NULL," \t\n\r\f")) n++; + + delete [] copy; + return n; +} + +/* ---------------------------------------------------------------------- */ + +void PairAmoeba::file_ffield(int nwords, char **words) +{ + double tmp; + + if (strcmp(words[0],"forcefield") == 0) { + int n = strlen(words[1]) + 1; + forcefield = new char[n]; + strcpy(forcefield,words[1]); + + } else if (strcmp(words[0],"bond-cubic") == 0) { + bond_cubic = utils::numeric(FLERR,words[1],true,lmp); + } else if (strcmp(words[0],"bond-quartic") == 0) { + bond_quartic = utils::numeric(FLERR,words[1],true,lmp); + + } else if (strcmp(words[0],"angle-cubic") == 0) { + angle_cubic = utils::numeric(FLERR,words[1],true,lmp); + } else if (strcmp(words[0],"angle-quartic") == 0) { + angle_quartic = utils::numeric(FLERR,words[1],true,lmp); + } else if (strcmp(words[0],"angle-pentic") == 0) { + angle_pentic = utils::numeric(FLERR,words[1],true,lmp); + } else if (strcmp(words[0],"angle-sextic") == 0) { + angle_sextic = utils::numeric(FLERR,words[1],true,lmp); + + } else if (strcmp(words[0],"opbendtype") == 0) { + if (strcmp(words[1],"allinger") == 0) opbendtype = ALLINGER; + else error->all(FLERR,"Unrecognized opbendtype in AMOEBA FF file"); + } else if (strcmp(words[0],"opbend-cubic") == 0) { + opbend_cubic = utils::numeric(FLERR,words[1],true,lmp); + } else if (strcmp(words[0],"opbend-quartic") == 0) { + opbend_quartic = utils::numeric(FLERR,words[1],true,lmp); + } else if (strcmp(words[0],"opbend-pentic") == 0) { + opbend_pentic = utils::numeric(FLERR,words[1],true,lmp); + } else if (strcmp(words[0],"opbend-sextic") == 0) { + opbend_sextic = utils::numeric(FLERR,words[1],true,lmp); + + } else if (strcmp(words[0],"torsionunit") == 0) { + torsion_unit = utils::numeric(FLERR,words[1],true,lmp); + + } else if (strcmp(words[0],"vdwtype") == 0) { + if (strcmp(words[1],"buffered-14-7") == 0) vdwtype = BUFFERED_14_7; + else error->all(FLERR,"Unrecognized vdwtype in AMOEBA FF file"); + } else if (strcmp(words[0],"radiusrule") == 0) { + if (strcmp(words[1],"arithmetic") == 0) radius_rule = ARITHMETIC; + else if (strcmp(words[1],"geometric") == 0) radius_rule = GEOMETRIC; + else if (strcmp(words[1],"cubic-mean") == 0) radius_rule = CUBIC_MEAN; + else error->all(FLERR,"Unrecognized radiusrule in AMOEBA FF file"); + } else if (strcmp(words[0],"radiustype") == 0) { + if (strcmp(words[1],"r-min") == 0) radius_type = R_MIN; + else if (strcmp(words[1],"sigma") == 0) radius_type = SIGMA; + else error->all(FLERR,"Unrecognized radiustype in AMOEBA FF file"); + } else if (strcmp(words[0],"radiussize") == 0) { + if (strcmp(words[1],"diameter") == 0) radius_size = DIAMETER; + else error->all(FLERR,"Unrecognized radiussize in AMOEBA FF file"); + } else if (strcmp(words[0],"epsilonrule") == 0) { + if (strcmp(words[1],"arithmetic") == 0) epsilon_rule = ARITHMETIC; + else if (strcmp(words[1],"geometric") == 0) epsilon_rule = GEOMETRIC; + else if (strcmp(words[1],"harmonic") == 0) epsilon_rule = HARMONIC; + else if (strcmp(words[1],"hhg") == 0) epsilon_rule = HHG; + else if (strcmp(words[1],"w-h") == 0) epsilon_rule = W_H; + else error->all(FLERR,"Unrecognized epsilonrule in AMOEBA FF file"); + + } else if (strcmp(words[0],"dielectric") == 0) { + am_dielectric = utils::numeric(FLERR,words[1],true,lmp); + } else if (strcmp(words[0],"polarization") == 0) { + if (strcmp(words[1],"mutual") == 0) poltyp = MUTUAL; + else if (strstr(words[1],"opt") == words[1]) { + poltyp = OPT; + if (strcmp(words[1],"opt") == 0) optorder = 4; + else optorder = utils::inumeric(FLERR,&words[1][3],true,lmp); + if (optorder < 1 || optorder > 6) + error->all(FLERR,"Unrecognized polarization OPTn in AMOEBA FF file"); + } else if (strcmp(words[1],"tcg") == 0) + error->all(FLERR,"Polarization TCG not yet supported in AMOEBA/HIPPO"); + else if (strcmp(words[1],"direct") == 0) poltyp = DIRECT; + else error->all(FLERR,"Unrecognized polarization in AMOEBA FF file"); + + // NOTE: enable all variants of special settings + // do these need to be set to defaults if don't appear in file? + + } else if (strcmp(words[0],"vdw-12-scale") == 0) { + special_hal[1] = utils::numeric(FLERR,words[1],true,lmp); + } else if (strcmp(words[0],"vdw-13-scale") == 0) { + special_hal[2] = utils::numeric(FLERR,words[1],true,lmp); + } else if (strcmp(words[0],"vdw-14-scale") == 0) { + special_hal[3] = utils::numeric(FLERR,words[1],true,lmp); + } else if (strcmp(words[0],"vdw-15-scale") == 0) { + special_hal[4] = utils::numeric(FLERR,words[1],true,lmp); + + } else if (strcmp(words[0],"rep-12-scale") == 0) { + special_repel[1] = utils::numeric(FLERR,words[1],true,lmp); + } else if (strcmp(words[0],"rep-13-scale") == 0) { + special_repel[2] = utils::numeric(FLERR,words[1],true,lmp); + } else if (strcmp(words[0],"rep-14-scale") == 0) { + special_repel[3] = utils::numeric(FLERR,words[1],true,lmp); + } else if (strcmp(words[0],"rep-15-scale") == 0) { + special_repel[4] = utils::numeric(FLERR,words[1],true,lmp); + + } else if (strcmp(words[0],"disp-12-scale") == 0) { + special_disp[1] = utils::numeric(FLERR,words[1],true,lmp); + } else if (strcmp(words[0],"disp-13-scale") == 0) { + special_disp[2] = utils::numeric(FLERR,words[1],true,lmp); + } else if (strcmp(words[0],"disp-14-scale") == 0) { + special_disp[3] = utils::numeric(FLERR,words[1],true,lmp); + } else if (strcmp(words[0],"disp-15-scale") == 0) { + special_disp[4] = utils::numeric(FLERR,words[1],true,lmp); + + } else if (strcmp(words[0],"mpole-12-scale") == 0) { + special_mpole[1] = utils::numeric(FLERR,words[1],true,lmp); + } else if (strcmp(words[0],"mpole-13-scale") == 0) { + special_mpole[2] = utils::numeric(FLERR,words[1],true,lmp); + } else if (strcmp(words[0],"mpole-14-scale") == 0) { + special_mpole[3] = utils::numeric(FLERR,words[1],true,lmp); + } else if (strcmp(words[0],"mpole-15-scale") == 0) { + special_mpole[4] = utils::numeric(FLERR,words[1],true,lmp); + + } else if (strcmp(words[0],"polar-12-scale") == 0) { + special_polar_pscale[1] = utils::numeric(FLERR,words[1],true,lmp); + } else if (strcmp(words[0],"polar-13-scale") == 0) { + special_polar_pscale[2] = utils::numeric(FLERR,words[1],true,lmp); + } else if (strcmp(words[0],"polar-14-scale") == 0) { + special_polar_pscale[3] = utils::numeric(FLERR,words[1],true,lmp); + } else if (strcmp(words[0],"polar-15-scale") == 0) { + special_polar_pscale[4] = utils::numeric(FLERR,words[1],true,lmp); + + } else if (strcmp(words[0],"polar-12-intra") == 0) { + special_polar_piscale[1] = utils::numeric(FLERR,words[1],true,lmp); + } else if (strcmp(words[0],"polar-13-intra") == 0) { + special_polar_piscale[2] = utils::numeric(FLERR,words[1],true,lmp); + } else if (strcmp(words[0],"polar-14-intra") == 0) { + special_polar_piscale[3] = utils::numeric(FLERR,words[1],true,lmp); + } else if (strcmp(words[0],"polar-15-intra") == 0) { + special_polar_piscale[4] = utils::numeric(FLERR,words[1],true,lmp); + + } else if (strcmp(words[0],"induce-12-scale") == 0) { + special_polar_wscale[1] = utils::numeric(FLERR,words[1],true,lmp); + } else if (strcmp(words[0],"induce-13-scale") == 0) { + special_polar_wscale[2] = utils::numeric(FLERR,words[1],true,lmp); + } else if (strcmp(words[0],"induce-14-scale") == 0) { + special_polar_wscale[3] = utils::numeric(FLERR,words[1],true,lmp); + } else if (strcmp(words[0],"induce-15-scale") == 0) { + special_polar_wscale[4] = utils::numeric(FLERR,words[1],true,lmp); + + } else if (strcmp(words[0],"direct-11-scale") == 0) { + polar_dscale = utils::numeric(FLERR,words[1],true,lmp); + } else if (strcmp(words[0],"direct-12-scale") == 0) { + // NOTE: could error check that value = 1 + } else if (strcmp(words[0],"direct-13-scale") == 0) { + } else if (strcmp(words[0],"direct-14-scale") == 0) { + + } else if (strcmp(words[0],"mutual-11-scale") == 0) { + polar_uscale = utils::numeric(FLERR,words[1],true,lmp); + } else if (strcmp(words[0],"mutual-12-scale") == 0) { + // NOTE: could error check that value = 1 + } else if (strcmp(words[0],"mutual-13-scale") == 0) { + } else if (strcmp(words[0],"mutual-14-scale") == 0) { + + } else { + char str[128]; + sprintf(str,"Unrecognized pair amoeba force field definition: %s",words[0]); + error->all(FLERR,str); + } +} + +/* ---------------------------------------------------------------------- */ + +void PairAmoeba::file_literature(int nwords, char **words) +{ + // do nothing, this section is skipped +} + +/* ---------------------------------------------------------------------- */ + +void PairAmoeba::file_atomtype(int nwords, char **words) +{ + if (nwords < 8) + error->all(FLERR,"AMOEBA atom type line is invalid"); + if (strcmp(words[0],"atom") != 0) + error->all(FLERR,"AMOEBA atom type line is invalid"); + + int itype = utils::inumeric(FLERR,words[1],true,lmp); + int iclass = utils::inumeric(FLERR,words[2],true,lmp); + + // grow per-type and per-class vecs/arrays as needed + + allocate_type_class(itype,iclass); + + n_amtype = MAX(n_amtype,itype); + n_amclass = MAX(n_amclass,iclass); + + // store words from line + + amtype_defined[itype] = 1; + amclass_defined[iclass] = 1; + amtype2class[itype] = iclass; + + atomic_num[itype] = utils::inumeric(FLERR,words[nwords-3],true,lmp); + am_mass[itype] = utils::numeric(FLERR,words[nwords-2],true,lmp); + valence[itype] = utils::inumeric(FLERR,words[nwords-1],true,lmp); +} + +/* ---------------------------------------------------------------------- */ + +void PairAmoeba::file_vdwl(int nwords, char **words) +{ + if (nwords != 4 && nwords != 5) + error->all(FLERR,"AMOEBA Van der Waals line is invalid"); + if (strcmp(words[0],"vdw") != 0) + error->all(FLERR,"AMOEBA Van der Waals line is invalid"); + + int iclass = utils::inumeric(FLERR,words[1],true,lmp); + if (iclass < 1 || iclass > n_amclass) + error->all(FLERR,"AMOEBA Van der Waals type index is invalid"); + + vdwl_sigma[iclass] = utils::numeric(FLERR,words[2],true,lmp); + vdwl_eps[iclass] = utils::numeric(FLERR,words[3],true,lmp); + if (nwords == 4) kred[iclass] = 0.0; + else kred[iclass] = utils::numeric(FLERR,words[4],true,lmp); +} + +/* ---------------------------------------------------------------------- */ + +void PairAmoeba::file_vdwl_pair(int nwords, char **words) +{ + if (nwords != 5) + error->all(FLERR,"AMOEBA Van der Waals pair line is invalid"); + if (strcmp(words[0],"vdwpr") != 0) + error->all(FLERR,"AMOEBA Van der Waals pair line is invalid"); + + if (nvdwl_pair == max_vdwl_pair) { + max_vdwl_pair += DELTA_VDWL_PAIR; + memory->grow(vdwl_class_pair,max_vdwl_pair,2,"amoeba:vdwl_class_pair"); + memory->grow(vdwl_sigma_pair,max_vdwl_pair,"amoeba:vdwl_sigma_pair"); + memory->grow(vdwl_eps_pair,max_vdwl_pair,"amoeba:vdwl_eps_pair"); + } + + vdwl_class_pair[nvdwl_pair][0] = utils::inumeric(FLERR,words[1],true,lmp); + vdwl_class_pair[nvdwl_pair][1] = utils::inumeric(FLERR,words[2],true,lmp); + vdwl_sigma_pair[nvdwl_pair] = utils::numeric(FLERR,words[3],true,lmp); + vdwl_eps_pair[nvdwl_pair] = utils::numeric(FLERR,words[4],true,lmp); + nvdwl_pair++; +} + +/* ---------------------------------------------------------------------- */ + +void PairAmoeba::file_bstretch(int nwords, char **words) +{ + if (nwords < 5) + error->all(FLERR,"AMOEBA bond stretch line is invalid"); + if (strcmp(words[0],"bond") != 0) + error->all(FLERR,"AMOEBA bond stretch line is invalid"); +} + +/* ---------------------------------------------------------------------- */ + +void PairAmoeba::file_sbend(int nwords, char **words) +{ + if (nwords != 6) + error->all(FLERR,"AMOEBA strectch-bend line is invalid"); + if (strstr(words[0],"strbnd") != words[0]) + error->all(FLERR,"AMOEBA strectch-bend line is invalid"); +} + +/* ---------------------------------------------------------------------- */ + +void PairAmoeba::file_abend(int nwords, char **words) +{ + if (nwords < 6) + error->all(FLERR,"AMOEBA angle bending line is invalid"); +} + +/* ---------------------------------------------------------------------- */ + +void PairAmoeba::file_pauli(int nwords, char **words) +{ + if (nwords < 5) + error->all(FLERR,"AMOEBA Pauli repulsion line is invalid"); + if (strstr(words[0],"repulsion") != words[0]) + error->all(FLERR,"AMOEBA Pauli repulsion line is invalid"); + + int itype = utils::inumeric(FLERR,words[1],true,lmp); + if (itype < 1 || itype > n_amtype) + error->all(FLERR,"AMOEBA Pauli repulsion type index is invalid"); + + // negate the elepr setting + + sizpr[itype] = utils::numeric(FLERR,words[2],true,lmp); + dmppr[itype] = utils::numeric(FLERR,words[3],true,lmp); + elepr[itype] = - fabs(utils::numeric(FLERR,words[4],true,lmp)); +} + +/* ---------------------------------------------------------------------- */ + +void PairAmoeba::file_dispersion(int nwords, char **words) +{ + if (nwords < 4) + error->all(FLERR,"AMOEBA dispersion line is invalid"); + if (strstr(words[0],"dispersion") != words[0]) + error->all(FLERR,"AMOEBA dipersion line is invalid"); + + int iclass = utils::inumeric(FLERR,words[1],true,lmp); + if (iclass < 1 || iclass > n_amclass) + error->all(FLERR,"AMOEBA dispersion class index is invalid"); + + csix[iclass] = utils::numeric(FLERR,words[2],true,lmp); + adisp[iclass] = utils::numeric(FLERR,words[3],true,lmp); +} + +/* ---------------------------------------------------------------------- */ + +void PairAmoeba::file_ub(int nwords, char **words) +{ + if (nwords != 6) + error->all(FLERR,"AMOEBA Urey-Bradley line is invalid"); + if (strstr(words[0],"ureybrad") != words[0]) + error->all(FLERR,"AMOEBA Urey-Bradley line is invalid"); +} + +/* ---------------------------------------------------------------------- */ + +void PairAmoeba::file_outplane(int nwords, char **words) +{ + if (nwords != 6) + error->all(FLERR,"AMOEBA out-of-plane bend line is invalid"); + if (strstr(words[0],"opbend") != words[0]) + error->all(FLERR,"AMOEBA out-of-plane bend line is invalid"); +} + +/* ---------------------------------------------------------------------- */ + +void PairAmoeba::file_torsion(int nwords, char **words) +{ + if (nwords != 14) + error->all(FLERR,"AMOEBA torsional line is invalid"); + if (strstr(words[0],"torsion") != words[0]) + error->all(FLERR,"AMOEBA torsional line is invalid"); +} + +/* ---------------------------------------------------------------------- */ + +void PairAmoeba::file_pitorsion(int nwords, char **words) +{ + if (nwords != 4) + error->all(FLERR,"AMOEBA pi-torsion line is invalid"); + if (strstr(words[0],"pitors") != words[0]) + error->all(FLERR,"AMOEBA pi-torsion line is invalid"); +} + +/* ---------------------------------------------------------------------- */ + +void PairAmoeba::file_multipole(int nwords, char **words) +{ + if (nwords < 12 || nwords > 15) + error->all(FLERR,"AMOEBA atomic multipole line is invalid"); + if (strstr(words[0],"multipole") != words[0]) + error->all(FLERR,"AMOEBA atomic multipole line is invalid"); + + int itype = utils::inumeric(FLERR,words[1],true,lmp); + if (itype < 1 || itype > n_amtype) + error->all(FLERR,"AMOEBA atomic multipole type index is invalid"); + + int iframe = nmultiframe[itype]; + if (iframe == MAX_FRAME_PER_TYPE) + error->all(FLERR,"AMOEBA MAX_FRAME_PER_TYPE is too small"); + + int extra; + if (nwords == 12) { + zpole[itype][iframe] = xpole[itype][iframe] = ypole[itype][iframe] = 0; + extra = 2; + } else if (nwords == 13) { + zpole[itype][iframe] = utils::inumeric(FLERR,words[2],true,lmp); + xpole[itype][iframe] = ypole[itype][iframe] = 0; + extra = 3; + } else if (nwords == 14) { + zpole[itype][iframe] = utils::inumeric(FLERR,words[2],true,lmp); + xpole[itype][iframe] = utils::inumeric(FLERR,words[3],true,lmp); + ypole[itype][iframe] = 0; + extra = 4; + } else if (nwords == 15) { + zpole[itype][iframe] = utils::inumeric(FLERR,words[2],true,lmp); + xpole[itype][iframe] = utils::inumeric(FLERR,words[3],true,lmp); + ypole[itype][iframe] = utils::inumeric(FLERR,words[4],true,lmp); + extra = 5; + } + + for (int i = 0; i < 10; i++) + fpole[itype][iframe][i] = utils::numeric(FLERR,words[extra+i],true,lmp); + + // convert fpole to be 13 values by symmetrizing quadrupole 3x3 matrix + // xx yx yy zx zy zz --> xx xy xz yz yy yz zx zy zz + + double xx = fpole[itype][iframe][4]; + double yx = fpole[itype][iframe][5]; + double yy = fpole[itype][iframe][6]; + double zx = fpole[itype][iframe][7]; + double zy = fpole[itype][iframe][8]; + double zz = fpole[itype][iframe][9]; + + fpole[itype][iframe][4] = xx; + fpole[itype][iframe][8] = yy; + fpole[itype][iframe][12] = zz; + fpole[itype][iframe][5] = fpole[itype][iframe][7] = yx; + fpole[itype][iframe][6] = fpole[itype][iframe][10] = zx; + fpole[itype][iframe][9] = fpole[itype][iframe][11] = zy; + + // rescale pole values to real units + // convert the dipole and quadrupole moments to Angstroms + // quadrupole terms divided by 3 for use as traceless values + + for (int i = 1; i < 4; i++) + fpole[itype][iframe][i] *= BOHR; + for (int i = 4; i < 13; i++) + fpole[itype][iframe][i] *= BOHR*BOHR / 3.0; + + // set mpaxis from xyz pole values + // uses both positive and negative values + + mpaxis[itype][iframe] = ZTHENX; + if (zpole[itype][iframe] == 0) mpaxis[itype][iframe] = NOFRAME; + if (zpole[itype][iframe] != 0 && xpole[itype][iframe] == 0) + mpaxis[itype][iframe] = ZONLY; + if (zpole[itype][iframe] < 0 || xpole[itype][iframe] < 0) + mpaxis[itype][iframe] = BISECTOR; + if (xpole[itype][iframe] < 0 && ypole[itype][iframe] < 0) + mpaxis[itype][iframe] = ZBISECT; + int xyzmax = MAX(zpole[itype][iframe],xpole[itype][iframe]); + xyzmax = MAX(xyzmax,ypole[itype][iframe]); + if (xyzmax < 0) mpaxis[itype][iframe] = THREEFOLD; + if (mpaxis[itype][iframe] < 0) error->all(FLERR,"Mpaxis value not set"); + + // now reset xyz pole to positive values + + if (xpole[itype][iframe] < 0) xpole[itype][iframe] = -xpole[itype][iframe]; + if (ypole[itype][iframe] < 0) ypole[itype][iframe] = -ypole[itype][iframe]; + if (zpole[itype][iframe] < 0) zpole[itype][iframe] = -zpole[itype][iframe]; + + nmultiframe[itype]++; +} + +/* ---------------------------------------------------------------------- */ + +void PairAmoeba::file_charge_penetration(int nwords, char **words) +{ + if (nwords < 4) + error->all(FLERR,"AMOEBA charge penetration line is invalid"); + if (strstr(words[0],"chgpen") != words[0]) + error->all(FLERR,"AMOEBA charge penetration line is invalid"); + + int iclass = utils::inumeric(FLERR,words[1],true,lmp); + if (iclass < 1 || iclass > n_amclass) + error->all(FLERR,"AMOEBA charge penetration class index is invalid"); + + pcore[iclass] = fabs(utils::numeric(FLERR,words[2],true,lmp)); + palpha[iclass] = utils::numeric(FLERR,words[3],true,lmp); +} + +/* ---------------------------------------------------------------------- */ + +void PairAmoeba::file_dippolar(int nwords, char **words) +{ + int nparams; + if (amoeba) nparams = 4; + if (hippo) nparams = 3; + + if (nwords < nparams) + error->all(FLERR,"AMOEBA dipole polarizability line is invalid"); + if (strstr(words[0],"polarize") != words[0]) + error->all(FLERR,"AMOEBA dipole polarizability line is invalid"); + + int itype = utils::inumeric(FLERR,words[1],true,lmp); + if (itype < 1 || itype > n_amtype) + error->all(FLERR,"AMOEBA dipole polarizabilty type index is invalid"); + + polarity[itype] = utils::numeric(FLERR,words[2],true,lmp); + pdamp[itype] = pow(polarity[itype],1.0/6.0); + if (amoeba) thole[itype] = utils::numeric(FLERR,words[3],true,lmp); + + // eventually AMOEBA+ files will set dirdamp + + dirdamp[itype] = 0.0; + + int ngroup = nwords - nparams; + if (ngroup > MAX_TYPE_PER_GROUP) + error->all(FLERR,"AMOEBA MAX_TYPE_PER_GROUP is too small"); + + npolgroup[itype] = ngroup; + for (int igroup = 0; igroup < ngroup; igroup++) + polgroup[itype][igroup] = + utils::inumeric(FLERR,words[nparams+igroup],true,lmp); +} + +/* ---------------------------------------------------------------------- */ + +void PairAmoeba::file_charge_transfer(int nwords, char **words) +{ + if (nwords < 4) + error->all(FLERR,"AMOEBA charge transfer line is invalid"); + if (strstr(words[0],"chgtrn") != words[0]) + error->all(FLERR,"AMOEBA charge transfer line is invalid"); + + int iclass = utils::inumeric(FLERR,words[1],true,lmp); + if (iclass < 1 || iclass > n_amclass) + error->all(FLERR,"AMOEBA charge transfer class index is invalid"); + + chgct[iclass] = utils::numeric(FLERR,words[2],true,lmp); + dmpct[iclass] = utils::numeric(FLERR,words[3],true,lmp); +} + +/* ---------------------------------------------------------------------- + initialize per type and per class data to NULL +------------------------------------------------------------------------- */ + +void PairAmoeba::initialize_type_class() +{ + n_amtype = n_amclass = 0; + max_amtype = max_amclass = 0; + nvdwl_pair = max_vdwl_pair = 0; + + // per type data + + amtype_defined = NULL; + amtype2class = NULL; + atomic_num = NULL; + valence = NULL; + am_mass = NULL; + am_q = NULL; + am_mu = NULL; + npolgroup = NULL; + polgroup = NULL; + polarity = NULL; + pdamp = NULL; + thole = NULL; + dirdamp = NULL; + sizpr = NULL; + dmppr = NULL; + elepr = NULL; + + nmultiframe = NULL; + mpaxis = NULL; + xpole = NULL; + ypole = NULL; + zpole = NULL; + fpole = NULL; + + // per class data + + amclass_defined = NULL; + vdwl_eps = NULL; + vdwl_sigma = NULL; + kred = NULL; + csix = NULL; + adisp = NULL; + chgct = NULL; + dmpct = NULL; + pcore = NULL; + palpha = NULL; + + // other + + vdwl_class_pair = NULL; + vdwl_sigma_pair = NULL; + vdwl_eps_pair = NULL; +} + +/* ---------------------------------------------------------------------- + allocate per type and per class data + vecs/arrays store info for itype = 1 to N_amtype inclusive + vecs/arrays store info for iclass = 1 to N_amclass inclusive + itype,iclass = line just read from AMOEBA force field file +------------------------------------------------------------------------- */ + +void PairAmoeba::allocate_type_class(int itype, int iclass) +{ + if (itype >= max_amtype) { + while (itype >= max_amtype) max_amtype += DELTA_TYPE_CLASS; + + memory->grow(amtype_defined,max_amtype,"amoeba:amtype_defined"); + memory->grow(amtype2class,max_amtype,"amoeba:amtype2class"); + + memory->grow(atomic_num,max_amtype,"amoeba:atomic_num"); + memory->grow(valence,max_amtype,"amoeba:valence"); + memory->grow(am_mass,max_amtype,"amoeba:am_mass"); + memory->grow(am_q,max_amtype,"amoeba:am_q"); + memory->grow(am_mu,max_amtype,3,"amoeba:am_mu"); + memory->grow(npolgroup,max_amtype,"amoeba:npolgroup"); + memory->grow(polgroup,max_amtype,MAX_TYPE_PER_GROUP,"amoeba:polgroup"); + memory->grow(polarity,max_amtype,"amoeba:polarity"); + memory->grow(pdamp,max_amtype,"amoeba:pdamp"); + memory->grow(thole,max_amtype,"amoeba:thole"); + memory->grow(dirdamp,max_amtype,"amoeba:dirdamp"); + memory->grow(sizpr,max_amtype,"amoeba:sizpr"); + memory->grow(dmppr,max_amtype,"amoeba:dmppr"); + memory->grow(elepr,max_amtype,"amoeba:elepr"); + + memory->grow(nmultiframe,max_amtype,"amoeba:nummulti"); + memory->grow(mpaxis,max_amtype,MAX_FRAME_PER_TYPE,"amoeba:mpaxis"); + memory->grow(xpole,max_amtype,MAX_FRAME_PER_TYPE,"amoeba:xpole"); + memory->grow(ypole,max_amtype,MAX_FRAME_PER_TYPE,"amoeba:ypole"); + memory->grow(zpole,max_amtype,MAX_FRAME_PER_TYPE,"amoeba:zpole"); + memory->grow(fpole,max_amtype,MAX_FRAME_PER_TYPE,13,"amoeba:fpole"); + } + + if (iclass >= max_amclass) { + while (iclass >= max_amclass) max_amclass += DELTA_TYPE_CLASS; + + memory->grow(amclass_defined,max_amtype,"amoeba:amclass_defined"); + + memory->grow(vdwl_eps,max_amclass,"amoeba:vdwl_eps"); + memory->grow(vdwl_sigma,max_amclass,"amoeba:vdwl_sigma"); + memory->grow(kred,max_amclass,"amoeba:kred"); + memory->grow(csix,max_amclass,"amoeba:csix"); + memory->grow(adisp,max_amclass,"amoeba:adisp"); + memory->grow(chgct,max_amclass,"amoeba:chgct"); + memory->grow(dmpct,max_amclass,"amoeba:dmpct"); + memory->grow(pcore,max_amtype,"amoeba:pcore"); + memory->grow(palpha,max_amtype,"amoeba:palpha"); + } +} + +/* ---------------------------------------------------------------------- + deallocate per type and per class data +------------------------------------------------------------------------- */ + +void PairAmoeba::deallocate_type_class() +{ + // per type data + + memory->destroy(amtype_defined); + memory->destroy(amtype2class); + memory->destroy(atomic_num); + memory->destroy(valence); + memory->destroy(am_mass); + memory->destroy(am_q); + memory->destroy(am_mu); + memory->destroy(npolgroup); + memory->destroy(polgroup); + memory->destroy(polarity); + memory->destroy(pdamp); + memory->destroy(thole); + memory->destroy(dirdamp); + memory->destroy(sizpr); + memory->destroy(dmppr); + memory->destroy(elepr); + + memory->destroy(nmultiframe); + memory->destroy(mpaxis); + memory->destroy(xpole); + memory->destroy(ypole); + memory->destroy(zpole); + memory->destroy(fpole); + + // per class data + + memory->destroy(amclass_defined); + memory->destroy(vdwl_eps); + memory->destroy(vdwl_sigma); + memory->destroy(kred); + memory->destroy(csix); + memory->destroy(adisp); + memory->destroy(chgct); + memory->destroy(dmpct); + memory->destroy(pcore); + memory->destroy(palpha); + + // other + + memory->destroy(vdwl_class_pair); + memory->destroy(vdwl_sigma_pair); + memory->destroy(vdwl_eps_pair); +} diff --git a/src/AMOEBA/amoeba_hal.cpp b/src/AMOEBA/amoeba_hal.cpp new file mode 100644 index 0000000000..3cf69f2536 --- /dev/null +++ b/src/AMOEBA/amoeba_hal.cpp @@ -0,0 +1,212 @@ +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#include "pair_amoeba.h" +#include +#include "atom.h" +#include "neigh_list.h" +#include "error.h" + +using namespace LAMMPS_NS; + +enum{VDWL,REPULSE,QFER,DISP,MPOLE,POLAR,USOLV,DISP_LONG,MPOLE_LONG,POLAR_LONG}; + +/* ---------------------------------------------------------------------- + hal = buffered 14-7 Vdwl interactions + adapted from Tinker ehal1c() routine +------------------------------------------------------------------------- */ + +void PairAmoeba::hal() +{ + int i,j,ii,jj,itype,jtype,iclass,jclass,iv,jv; + int special_which; + double e,de,eps,rdn; + double fgrp,rv,rv7; + double xi,yi,zi; + double xr,yr,zr; + double redi,rediv; + double redj,redjv; + double dedx,dedy,dedz; + double rho,rho6,rho7; + double tau,tau7,scal; + double s1,s2,t1,t2; + double dt1drho,dt2drho; + double dtau,gtau; + double taper,dtaper; + double rik,rik2,rik3; + double rik4,rik5; + double rik6,rik7; + double vxx,vyy,vzz; + double vyx,vzx,vzy; + double factor_hal; + double vir[6]; + + int inum,jnum; + int *ilist,*jlist,*numneigh,**firstneigh; + + // set cutoffs and taper coeffs + + choose(VDWL); + + // owned atoms + + double **x = atom->x; + int nlocal = atom->nlocal; + + // neigh list + + inum = list->inum; + ilist = list->ilist; + numneigh = list->numneigh; + firstneigh = list->firstneigh; + + // find van der Waals energy and derivatives via neighbor list + + for (ii = 0; ii < inum; ii++) { + i = ilist[ii]; + itype = amtype[i]; + iclass = amtype2class[itype]; + jlist = firstneigh[i]; + jnum = numneigh[i]; + + redi = kred[iclass]; + rediv = 1.0 - redi; + xi = xred[i][0]; + yi = xred[i][1]; + zi = xred[i][2]; + + for (jj = 0; jj < jnum; jj++) { + j = jlist[jj]; + special_which = sbmask15(j); + factor_hal = special_hal[special_which]; + if (factor_hal == 0.0) continue; + j &= NEIGHMASK15; + + xr = xi - xred[j][0]; + yr = yi - xred[j][1]; + zr = zi - xred[j][2]; + rik2 = xr*xr + yr*yr + zr*zr; + + if (rik2 > off2) continue; + + // compute the energy contribution for this interaction + + jtype = amtype[j]; + jclass = amtype2class[jtype]; + + // check for an interaction distance less than the cutoff + // special_which = 3 is a 1-4 neighbor with its own sigma,epsilon + + rik = sqrt(rik2); + rv = radmin[iclass][jclass]; + eps = epsilon[iclass][jclass]; + if (special_which == 3) { + rv = radmin4[iclass][jclass]; + eps = epsilon4[iclass][jclass]; + } + eps *= factor_hal; + + rv7 = pow(rv,7.0); + rik6 = pow(rik2,3.0); + rik7 = rik6 * rik; + rho = rik7 + ghal*rv7; + tau = (dhal+1.0) / (rik + dhal*rv); + tau7 = pow(tau,7.0); + dtau = tau / (dhal+1.0); + gtau = eps*tau7*rik6*(ghal+1.0)*pow(rv7/rho,2.0); + e = eps*tau7*rv7*((ghal+1.0)*rv7/rho-2.0); + de = -7.0 * (dtau*e+gtau); + + // use energy switching if near the cutoff distance + + if (rik2 > cut2) { + rik3 = rik2 * rik; + rik4 = rik2 * rik2; + rik5 = rik2 * rik3; + taper = c5*rik5 + c4*rik4 + c3*rik3 + c2*rik2 + c1*rik + c0; + dtaper = 5.0*c5*rik4 + 4.0*c4*rik3 + 3.0*c3*rik2 + 2.0*c2*rik + c1; + de = e*dtaper + de*taper; + e *= taper; + } + + ehal += e; + + // find the chain rule terms for derivative components + + de = de / rik; + dedx = de * xr; + dedy = de * yr; + dedz = de * zr; + + // increment the total van der Waals energy and derivatives + // if jv < 0, trigger an error, needed H-bond partner is missing + + iv = ired2local[i]; + jv = ired2local[j]; + if (jv < 0) + error->one(FLERR,"AMOEBA hal cannot find H bond partner - " + "ghost comm is too short"); + + if (i == iv) { + fhal[i][0] += dedx; + fhal[i][1] += dedy; + fhal[i][2] += dedz; + } else { + fhal[i][0] += dedx*redi; + fhal[i][1] += dedy*redi; + fhal[i][2] += dedz*redi; + fhal[iv][0] += dedx*rediv; + fhal[iv][1] += dedy*rediv; + fhal[iv][2] += dedz*rediv; + } + + if (j == jv) { + fhal[j][0] -= dedx; + fhal[j][1] -= dedy; + fhal[j][2] -= dedz; + } else { + redj = kred[jclass]; + redjv = 1.0 - redj; + fhal[j][0] -= dedx*redj; + fhal[j][1] -= dedy*redj; + fhal[j][2] -= dedz*redj; + fhal[jv][0] -= dedx*redjv; + fhal[jv][1] -= dedy*redjv; + fhal[jv][2] -= dedz*redjv; + } + + // increment the internal virial tensor components + + vxx = xr * dedx; + vyx = yr * dedx; + vzx = zr * dedx; + vyy = yr * dedy; + vzy = zr * dedy; + vzz = zr * dedz; + + virhal[0] += vxx; + virhal[1] += vyy; + virhal[2] += vzz; + virhal[3] += vyx; + virhal[4] += vzx; + virhal[5] += vzy; + + // energy = e + // virial = 6-vec vir + // NOTE: add tally function + + if (evflag) { + } + } + } +} diff --git a/src/AMOEBA/amoeba_induce.cpp b/src/AMOEBA/amoeba_induce.cpp new file mode 100644 index 0000000000..c8f361053c --- /dev/null +++ b/src/AMOEBA/amoeba_induce.cpp @@ -0,0 +1,1994 @@ +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#include "pair_amoeba.h" +#include +#include +#include +#include "amoeba_convolution.h" +#include "atom.h" +#include "domain.h" +#include "comm.h" +#include "fix_store.h" +#include "neigh_list.h" +#include "fft3d_wrap.h" +#include "my_page.h" +#include "math_const.h" +#include "memory.h" +#include "error.h" + +using namespace LAMMPS_NS; +using namespace MathConst; + +enum{INDUCE,RSD,SETUP_AMOEBA,SETUP_HIPPO,KMPOLE,AMGROUP}; // forward comm +enum{FIELD,ZRSD,TORQUE,UFLD}; // reverse comm +enum{VDWL,REPULSE,QFER,DISP,MPOLE,POLAR,USOLV,DISP_LONG,MPOLE_LONG,POLAR_LONG}; +enum{MUTUAL,OPT,TCG,DIRECT}; +enum{GEAR,ASPC,LSQR}; +enum{BUILD,APPLY}; +enum{GORDON1,GORDON2}; + +#define DEBYE 4.80321 // conversion factor from q-Angs (real units) to Debye + +/* ---------------------------------------------------------------------- + induce = induced dipole moments via pre-conditioned CG solver + adapted from Tinker induce0a() routine +------------------------------------------------------------------------- */ + +void PairAmoeba::induce() +{ + bool done; + int i,j,m,ii,itype; + int iter,maxiter; + double polmin; + double eps,epsold; + double epsd,epsp; + double udsum,upsum; + double a,ap,b,bp; + double sum,sump,term; + double reduce[4],allreduce[4]; + + double *poli; + double **conj,**conjp; + double **vec,**vecp; + double **udir,**usum,**usump; + + int debug = 1; + + // set cutoffs, taper coeffs, and PME params + // create qfac here, free at end of polar() + + if (use_ewald) { + choose(POLAR_LONG); + int nmine = p_kspace->nfft_owned; + memory->create(qfac,nmine,"ameoba/induce:qfac"); + } else choose(POLAR); + + // owned atoms + + double **x = atom->x; + double **f = atom->f; + int nlocal = atom->nlocal; + + // zero out the induced dipoles at each site + + for (i = 0; i < nlocal; i++) { + for (j = 0; j < 3; j++) { + uind[i][j] = 0.0; + uinp[i][j] = 0.0; + } + } + + // allocation of arrays + // NOTE: not all are used by all methods + // NOTE: could be re-allocated dynamically + + memory->create(poli,nlocal,"ameoba/induce:poli"); + memory->create(conj,nlocal,3,"ameoba/induce:conj"); + memory->create(conjp,nlocal,3,"ameoba/induce:conjp"); + memory->create(vec,nlocal,3,"ameoba/induce:vec"); + memory->create(vecp,nlocal,3,"ameoba/induce:vecp"); + memory->create(udir,nlocal,3,"ameoba/induce:udir"); + memory->create(usum,nlocal,3,"ameoba/induce:usum"); + memory->create(usump,nlocal,3,"ameoba/induce:usump"); + + // get the electrostatic field due to permanent multipoles + + dfield0c(field,fieldp); + + // reverse comm to sum field,fieldp from ghost atoms to owned atoms + + crstyle = FIELD; + comm->reverse_comm_pair(this); + + // DEBUG statements + + /* + for (i = 0; i < nlocal; i++) + if (atom->tag[i] == 1) + printf("AAA FIELD atom %d: field %g %g %g: fieldp %g %g %g\n", + atom->tag[i], + field[i][0],field[i][1],field[i][2], + fieldp[i][0],fieldp[i][1],fieldp[i][2]); + */ + + // set induced dipoles to polarizability times direct field + + for (i = 0; i < nlocal; i++) { + itype = amtype[i]; + for (j = 0; j < 3; j++) { + udir[i][j] = polarity[itype] * field[i][j]; + udirp[i][j] = polarity[itype] * fieldp[i][j]; + if (pcgguess) { + uind[i][j] = udir[i][j]; + uinp[i][j] = udirp[i][j]; + } + } + } + + // DEBUG statements + + /* + for (i = 0; i < nlocal; i++) + if (atom->tag[i] == 1) + printf("AAA UDIR atom %d: udir %g %g %g: udirp %g %g %g\n", + atom->tag[i], + DEBYE*udir[i][0],DEBYE*udir[i][1],DEBYE*udir[i][2], + DEBYE*udirp[i][0],DEBYE*udirp[i][1],DEBYE*udirp[i][2]); + */ + + // get induced dipoles via the OPT extrapolation method + // NOTE: any way to rewrite these loops to avoid allocating + // uopt,uoptp with a optorder+1 dimension, just optorder ?? + // since no need to store optorder+1 values after these loops + + if (poltyp == OPT) { + for (i = 0; i < nlocal; i++) { + for (j = 0; j < 3; j++) { + uopt[i][0][j] = udir[i][j]; + uoptp[i][0][j] = udirp[i][j]; + } + } + + for (m = 1; m <= optorder; m++) { + optlevel = m - 1; // used in umutual1() for fopt,foptp + + cfstyle = INDUCE; + comm->forward_comm_pair(this); + + ufield0c(field,fieldp); + + crstyle = FIELD; + comm->reverse_comm_pair(this); + + for (i = 0; i < nlocal; i++) { + itype = amtype[i]; + for (j = 0; j < 3; j++) { + uopt[i][m][j] = polarity[itype] * field[i][j]; + uoptp[i][m][j] = polarity[itype] * fieldp[i][j]; + uind[i][j] = uopt[i][m][j]; + uinp[i][j] = uoptp[i][m][j]; + } + } + } + + for (i = 0; i < nlocal; i++) { + for (j = 0; j < 3; j++) { + uind[i][j] = 0.0; + uinp[i][j] = 0.0; + usum[i][j] = 0.0; + usump[i][j] = 0.0; + for (m = 0; m <= optorder; m++) { + usum[i][j] += uopt[i][m][j]; + usump[i][j] += uoptp[i][m][j]; + uind[i][j] += copt[m]*usum[i][j]; + uinp[i][j] += copt[m]*usump[i][j]; + } + } + } + } + + // set tolerances for computation of mutual induced dipoles + + if (poltyp == MUTUAL) { + done = false; + maxiter = 100; + iter = 0; + polmin = 0.00000001; + eps = 100.0; + + // estimate induced dipoles using a polynomial predictor + + if (use_pred && nualt == maxualt) { + ulspred(); + + double ***udalt = fixudalt->tstore; + double ***upalt = fixupalt->tstore; + + for (i = 0; i < nlocal; i++) { + for (j = 0; j < 3; j++) { + udsum = 0.0; + upsum = 0.0; + for (m = 0; m < nualt; m++) { + udsum += bpred[m]*udalt[i][m][j]; + upsum += bpredp[m]*upalt[i][m][j]; + } + uind[i][j] = udsum; + uinp[i][j] = upsum; + } + } + } + + // estimate induced dipoles via inertial extended Lagrangian + // not supported for now + // requires uaux,upaux to persist with each atom + // also requires a velocity vector(s) to persist + // also requires updating uaux,upaux in the Verlet integration + + /* + if (use_ielscf) { + for (i = 0; i < nlocal; i++) { + for (j = 0; j < 3; j++) { + uind[i][j] = uaux[i][j]; + uinp[i][j] = upaux[i][j]; + } + } + } + */ + + // get the electrostatic field due to induced dipoles + + cfstyle = INDUCE; + comm->forward_comm_pair(this); + + ufield0c(field,fieldp); + + crstyle = FIELD; + comm->reverse_comm_pair(this); + + // DEBUG statements + + /* + for (i = 0; i < nlocal; i++) + if (atom->tag[i] == 1) + printf("UFIELD atom %d: uind %g %g %g uinp %g %g %g " + "field %g %g %g: fieldp %g %g %g\n", + atom->tag[i], + uind[i][0],uind[i][1],uind[i][2], + uinp[i][0],uinp[i][1],uinp[i][2], + field[i][0],field[i][1],field[i][2], + fieldp[i][0],fieldp[i][1],fieldp[i][2]); + */ + + // set initial conjugate gradient residual and conjugate vector + + for (i = 0; i < nlocal; i++) { + itype = amtype[i]; + + poli[i] = MAX(polmin,polarity[itype]); + for (j = 0; j < 3; j++) { + if (pcgguess) { + rsd[i][j] = (udir[i][j]-uind[i][j])/poli[i] + field[i][j]; + rsdp[i][j] = (udirp[i][j]-uinp[i][j])/poli[i] + fieldp[i][j]; + } else { + rsd[i][j] = udir[i][j] / poli[i]; + rsdp[i][j] = udirp[i][j] / poli[i]; + } + zrsd[i][j] = rsd[i][j]; + zrsdp[i][j] = rsdp[i][j]; + } + } + + if (pcgprec) { + cfstyle = RSD; + comm->forward_comm_pair(this); + uscale0b(BUILD,rsd,rsdp,zrsd,zrsdp); + uscale0b(APPLY,rsd,rsdp,zrsd,zrsdp); + crstyle = ZRSD; + comm->reverse_comm_pair(this); + } + + for (i = 0; i < nlocal; i++) { + for (j = 0; j < 3; j++) { + conj[i][j] = zrsd[i][j]; + conjp[i][j] = zrsdp[i][j]; + } + } + + // DEBUG statements + + /* + for (i = 0; i < nlocal; i++) + if (atom->tag[i] == 1) + printf("CONJ atom %d: rsd %g %g %g rsdp %g %g %g " + "conj %g %g %g: conjp %g %g %g\n", + atom->tag[i], + rsd[i][0],rsd[i][1],rsd[i][2], + rsdp[i][0],rsdp[i][1],rsdp[i][2], + conj[i][0],conj[i][1],conj[i][2], + conjp[i][0],conjp[i][1],conjp[i][2]); + */ + + // conjugate gradient iteration of the mutual induced dipoles + + while (!done) { + iter++; + + for (i = 0; i < nlocal; i++) { + for (j = 0; j < 3; j++) { + vec[i][j] = uind[i][j]; + vecp[i][j] = uinp[i][j]; + uind[i][j] = conj[i][j]; + uinp[i][j] = conjp[i][j]; + } + } + + cfstyle = INDUCE; + comm->forward_comm_pair(this); + + ufield0c(field,fieldp); + + //error->all(FLERR,"STOP"); + + crstyle = FIELD; + comm->reverse_comm_pair(this); + + // DEBUG statements + + /* + for (i = 0; i < nlocal; i++) + if (atom->tag[i] == 1) + printf("POST-COMM FIELD atom %d: field %g %g %g: fieldp %g %g %g\n", + atom->tag[i], + uind[i][0],uind[i][1],uind[i][2], + uinp[i][0],uinp[i][1],uinp[i][2], + field[i][0],field[i][1],field[i][2], + fieldp[i][0],fieldp[i][1],fieldp[i][2]); + */ + + for (i = 0; i < nlocal; i++) { + for (j = 0; j < 3; j++) { + uind[i][j] = vec[i][j]; + uinp[i][j] = vecp[i][j]; + vec[i][j] = conj[i][j]/poli[i] - field[i][j]; + vecp[i][j] = conjp[i][j]/poli[i] - fieldp[i][j]; + } + } + + a = 0.0; + ap = 0.0; + sum = 0.0; + sump = 0.0; + + for (i = 0; i < nlocal; i++) { + for (j = 0; j < 3; j++) { + a += conj[i][j]*vec[i][j]; + ap += conjp[i][j]*vecp[i][j]; + sum += rsd[i][j]*zrsd[i][j]; + sump += rsdp[i][j]*zrsdp[i][j]; + } + } + + reduce[0] = a; + reduce[1] = ap; + reduce[2] = sum; + reduce[3] = sump; + MPI_Allreduce(reduce,allreduce,4,MPI_DOUBLE,MPI_SUM,world); + a = allreduce[0]; + ap = allreduce[1]; + sum = allreduce[2]; + sump = allreduce[3]; + + if (a != 0.0) a = sum / a; + if (ap != 0.0) ap = sump / ap; + + for (i = 0; i < nlocal; i++) { + for (j = 0; j < 3; j++) { + uind[i][j] = uind[i][j] + a*conj[i][j]; + uinp[i][j] = uinp[i][j] + ap*conjp[i][j]; + rsd[i][j] = rsd[i][j] - a*vec[i][j]; + rsdp[i][j] = rsdp[i][j] - ap*vecp[i][j]; + zrsd[i][j] = rsd[i][j]; + zrsdp[i][j] = rsdp[i][j]; + } + } + + // DEBUG statements + + /* + for (i = 0; i < nlocal; i++) + if (atom->tag[i] == 1) + printf("POST-MPI UIND atom %d: uind %g %g %g: uinp %g %g %g\n", + atom->tag[i], + uind[i][0],uind[i][1],uind[i][2], + uinp[i][0],uinp[i][1],uinp[i][2]); + */ + + if (pcgprec) { + cfstyle = RSD; + comm->forward_comm_pair(this); + uscale0b(APPLY,rsd,rsdp,zrsd,zrsdp); + crstyle = ZRSD; + comm->reverse_comm_pair(this); + } + + // DEBUG statements + + /* + for (i = 0; i < nlocal; i++) + if (atom->tag[i] == 1) + printf("POST-PRECOND atom %d: rsd %g %g %g: rsdp %g %g %g " + "zrsd %g %g %g: zrsdp %g %g %g\n", + atom->tag[i], + rsd[i][0],rsd[i][1],rsd[i][2], + rsdp[i][0],rsdp[i][1],rsdp[i][2], + zrsd[i][0],zrsd[i][1],zrsd[i][2], + zrsdp[i][0],zrsdp[i][1],zrsdp[i][2]); + */ + + b = 0.0; + bp = 0.0; + + for (i = 0; i < nlocal; i++) { + for (j = 0; j < 3; j++) { + b += rsd[i][j]*zrsd[i][j]; + bp += rsdp[i][j]*zrsdp[i][j]; + } + } + + // NOTE: comp of b,bp and allreduce only needed if pcgprec ? + + reduce[0] = b; + reduce[1] = bp; + MPI_Allreduce(reduce,allreduce,4,MPI_DOUBLE,MPI_SUM,world); + b = allreduce[0]; + bp = allreduce[1]; + + if (sum != 0.0) b /= sum; + if (sump != 0.0) bp /= sump; + + epsd = 0.0; + epsp = 0.0; + + for (i = 0; i < nlocal; i++) { + for (j = 0; j < 3; j++) { + conj[i][j] = zrsd[i][j] + b*conj[i][j]; + conjp[i][j] = zrsdp[i][j] + bp*conjp[i][j]; + epsd += rsd[i][j]*rsd[i][j]; + epsp += rsdp[i][j]*rsdp[i][j]; + } + } + + reduce[0] = epsd; + reduce[1] = epsp; + MPI_Allreduce(reduce,allreduce,4,MPI_DOUBLE,MPI_SUM,world); + epsd = allreduce[0]; + epsp = allreduce[1]; + + // check the convergence of the mutual induced dipoles + + epsold = eps; + eps = MAX(epsd,epsp); + eps = DEBYE * sqrt(eps/atom->natoms); + + /* + if (debug) { + if (comm->me == 0 && screen) { + fprintf(screen,"SCF induced dipole moments: " + "iter %d, RMS residual (Debye) %g\n",iter,eps); + } + } + */ + + if (eps < poleps) done = true; + if (eps > epsold) done = true; + if (iter >= politer) done = true; + + // apply a "peek" iteration to the mutual induced dipoles + + // DEBUG statements + + /* + printf("DONE %d\n",done); + for (i = 0; i < nlocal; i++) + printf("PRE-DONE UIND atom %d: uind %g %g %g: uinp %g %g %g\n", + atom->tag[i], + uind[i][0],uind[i][1],uind[i][2], + uinp[i][0],uinp[i][1],uinp[i][2]); + */ + + if (done) { + for (i = 0; i < nlocal; i++) { + term = pcgpeek * poli[i]; + for (j = 0; j < 3; j++) { + uind[i][j] += term*rsd[i][j]; + uinp[i][j] += term*rsdp[i][j]; + } + } + } + + // DEBUG statements + + /* + for (i = 0; i < nlocal; i++) + if (atom->tag[i] == 1) + printf("POST-DONE UIND atom %d: uind %g %g %g: uinp %g %g %g\n", + atom->tag[i], + DEBYE*uind[i][0],DEBYE*uind[i][1],DEBYE*uind[i][2], + DEBYE*uinp[i][0],DEBYE*uinp[i][1],DEBYE*uinp[i][2]); + */ + } + + // terminate the calculation if dipoles failed to converge + // NOTE: could make this an error + + if (iter >= maxiter || eps > epsold) + if (me == 0) + error->warning(FLERR,"AMOEBA induced dipoles did not converge"); + } + + // DEBUG output to dump file + + if (uind_flag) + dump6(fp_uind,"id uindx uindy uindz uinpx uinpy uinpz",DEBYE,uind,uinp); + + // deallocation of arrays + + memory->destroy(poli); + memory->destroy(conj); + memory->destroy(conjp); + memory->destroy(vec); + memory->destroy(vecp); + memory->destroy(udir); + memory->destroy(usum); + memory->destroy(usump); + + // update the lists of previous induced dipole values + // shift previous m values up to m+1, add new values at m = 0 + // only when preconditioner is used + + if (use_pred) { + double ***udalt = fixudalt->tstore; + double ***upalt = fixupalt->tstore; + + nualt = MIN(nualt+1,maxualt); + for (i = 0; i < nlocal; i++) { + for (j = 0; j < 3; j++) { + for (m = nualt-1; m > 0; m--) { + udalt[i][m][j] = udalt[i][m-1][j]; + upalt[i][m][j] = upalt[i][m-1][j]; + } + udalt[i][0][j] = uind[i][j]; + upalt[i][0][j] = uinp[i][j]; + } + } + } +} + +/* ---------------------------------------------------------------------- + ulspred = induced dipole prediction coeffs + + ulspred uses standard extrapolation or a least squares fit + to set coefficients of an induced dipole predictor polynomial + literature references: + + J. Kolafa, "Time-Reversible Always Stable Predictor-Corrector + Method for Molecular Dynamics of Polarizable Molecules", Journal + of Computational Chemistry, 25, 335-342 (2004) + + W. Wang and R. D. Skeel, "Fast Evaluation of Polarizable Forces", + Journal of Chemical Physics, 123, 164107 (2005) +------------------------------------------------------------------------- */ + +void PairAmoeba::ulspred() +{ + int i,j,k,m; + double coeff,udk,upk; + double amax,apmax; + + // set the Gear predictor binomial coefficients + + if (polpred == GEAR) { + for (i = 0; i < nualt; i++) { + coeff = gear[i]; + bpred[i] = coeff; + bpredp[i] = coeff; + bpreds[i] = coeff; + bpredps[i] = coeff; + } + + // set always stable predictor-corrector (ASPC) coefficients + + } else if (polpred == ASPC) { + for (i = 0; i < nualt; i++) { + coeff = aspc[i]; + bpred[i] = coeff; + bpredp[i] = coeff; + bpreds[i] = coeff; + bpredps[i] = coeff; + } + + // derive normal equations corresponding to least squares fit + // NOTE: check all N vs N-1 indices in code from here down + + } else if (polpred == LSQR) { + double ***udalt = fixudalt->tstore; + double ***upalt = fixupalt->tstore; + + for (k = 0; k < nualt; k++) { + b_ualt[k] = 0.0; + bp_ualt[k] = 0.0; + for (m = k; m < nualt; m++) { + c_ualt[k][m] = 0.0; + cp_ualt[k][m] = 0.0; + } + } + + int nlocal = atom->nlocal; + for (i = 0; i < nlocal; i++) { + for (j = 0; j < 3; j++) { + for (k = 0; k < nualt; k++) { + udk = udalt[i][k][j]; + upk = upalt[i][k][j]; + for (m = k; m < nualt; m++) { + c_ualt[k][m] += udk*udalt[i][m][j]; + cp_ualt[k][m] += upk*upalt[i][m][j]; + } + } + } + } + + i = 0; + for (k = 1; k < nualt; k++) { + b_ualt[k-1] = c_ualt[0][k]; + bp_ualt[k-1] = cp_ualt[0][k]; + for (m = k; m < nualt; m++) { + a_ualt[i] = c_ualt[k][m]; + ap_ualt[i] = cp_ualt[k][m]; + i++; + } + } + + // check for nonzero coefficients and solve normal equations + + k = nualt - 1; + amax = 0.0; + apmax = 0.0; + for (i = 0; i < k*(k+1)/2; i++) { + amax = MAX(amax,a_ualt[i]); + apmax = MAX(apmax,ap_ualt[i]); + } + if (amax != 0.0) cholesky(nualt-1,a_ualt,b_ualt); + if (apmax != 0.0) cholesky(nualt-1,ap_ualt,bp_ualt); + + // transfer the final solution to the coefficient vector + + for (k = 0; k < nualt-1; k++) { + bpred[k] = b_ualt[k]; + bpredp[k] = bp_ualt[k]; + bpreds[k] = b_ualt[k]; + bpredps[k] = bp_ualt[k]; + } + bpred[nualt-1] = 0.0; + bpredp[nualt-1] = 0.0; + bpreds[nualt-1] = 0.0; + bpredps[nualt-1] = 0.0; + } +} + +/* ---------------------------------------------------------------------- + ufield0c = mutual induction via Ewald sum + ufield0c computes the mutual electrostatic field due to + induced dipole moments via Ewald summation +------------------------------------------------------------------------- */ + +void PairAmoeba::ufield0c(double **field, double **fieldp) +{ + int i,j,ii; + double term; + double ucell[3],ucellp[3]; + + int inum; + int *ilist; + + // zero field,fieldp for owned and ghost atoms + + int nlocal = atom->nlocal; + int nall = nlocal + atom->nghost; + + for (i = 0; i < nall; i++) { + for (j = 0; j < 3; j++) { + field[i][j] = 0.0; + fieldp[i][j] = 0.0; + } + } + + // get the reciprocal space part of the mutual field + + if (kspace_flag) umutual1(field,fieldp); + + // get the real space portion of the mutual field + + if (rspace_flag) umutual2b(field,fieldp); + + // add the self-energy portion of the mutual field + + term = (4.0/3.0) * aewald*aewald*aewald / MY_PIS; + for (i = 0; i < nlocal; i++) { + for (j = 0; j < 3; j++) { + field[i][j] += term*uind[i][j]; + fieldp[i][j] += term*uinp[i][j]; + } + + /* + // DEBUG + + printf("UMUTUAL2B SELF i %d term %g aewald %g uind %g %g %g field %g %g %g\n", + atom->tag[i],term,aewald, + uind[i][0],uind[i][1],uind[i][2],field[i][0],field[i][1],field[i][2]); + */ + } +} + +/* ---------------------------------------------------------------------- + uscale0b = dipole preconditioner via neigh list + uscale0b builds and applies a preconditioner for the conjugate + gradient induced dipole solver using a neighbor pair list +------------------------------------------------------------------------- */ + +void PairAmoeba::uscale0b(int mode, double **rsd, double **rsdp, + double **zrsd, double **zrsdp) +{ + int i,j,k,m,itype,jtype,iclass,jclass,igroup,jgroup; + int ii,jj; + double xi,yi,zi; + double xr,yr,zr; + double r,r2,rr3,rr5; + double pdi,pti; + double polmin; + double poli,polik; + double corei,corek; + double vali,valk; + double alphai,alphak; + double damp,expdamp; + double pgamma; + double scale3,scale5; + double m1,m2,m3; + double m4,m5,m6; + double factor_uscale,factor_wscale; + double dmpik[5]; + + // owned atoms + + pval = atom->dvector[index_pval]; + + double **x = atom->x; + int nlocal = atom->nlocal; + int nall = nlocal + atom->nghost; + + // neighbor list info + + int inum,jnum; + int *ilist,*jlist; + double *pclist; + + inum = list->inum; + ilist = list->ilist; + + // ------------------------------------------------ + // apply the preconditioning matrix to the current residual + // ------------------------------------------------ + + if (mode == APPLY) { + + // use diagonal preconditioner elements as first approximation + + polmin = 0.00000001; + for (i = 0; i < nlocal; i++) { + itype = amtype[i]; + poli = udiag * MAX(polmin,polarity[itype]); + for (j = 0; j < 3; j++) { + zrsd[i][j] = poli * rsd[i][j]; + zrsdp[i][j] = poli * rsdp[i][j]; + } + } + + // zero zrsd,zrsdp for ghost atoms only + + for (i = nlocal; i < nall; i++) { + for (j = 0; j < 3; j++) { + zrsd[i][j] = 0.0; + zrsdp[i][j] = 0.0; + } + } + + // use the off-diagonal preconditioner elements in second phase + + for (ii = 0; ii < inum; ii++) { + i = ilist[ii]; + jlist = firstneigh_precond[i]; + jnum = numneigh_precond[i]; + pclist = firstneigh_pcpc[i]; + + for (jj = 0; jj < jnum; jj++) { + j = jlist[jj]; + j &= NEIGHMASK15; + + m1 = pclist[0]; + m2 = pclist[1]; + m3 = pclist[2]; + m4 = pclist[3]; + m5 = pclist[4]; + m6 = pclist[5]; + + zrsd[i][0] += m1*rsd[j][0] + m2*rsd[j][1] + m3*rsd[j][2]; + zrsd[i][1] += m2*rsd[j][0] + m4*rsd[j][1] + m5*rsd[j][2]; + zrsd[i][2] += m3*rsd[j][0] + m5*rsd[j][1] + m6*rsd[j][2]; + zrsd[j][0] += m1*rsd[i][0] + m2*rsd[i][1] + m3*rsd[i][2]; + zrsd[j][1] += m2*rsd[i][0] + m4*rsd[i][1] + m5*rsd[i][2]; + zrsd[j][2] += m3*rsd[i][0] + m5*rsd[i][1] + m6*rsd[i][2]; + zrsdp[i][0] += m1*rsdp[j][0] + m2*rsdp[j][1] + m3*rsdp[j][2]; + zrsdp[i][1] += m2*rsdp[j][0] + m4*rsdp[j][1] + m5*rsdp[j][2]; + zrsdp[i][2] += m3*rsdp[j][0] + m5*rsdp[j][1] + m6*rsdp[j][2]; + zrsdp[j][0] += m1*rsdp[i][0] + m2*rsdp[i][1] + m3*rsdp[i][2]; + zrsdp[j][1] += m2*rsdp[i][0] + m4*rsdp[i][1] + m5*rsdp[i][2]; + zrsdp[j][2] += m3*rsdp[i][0] + m5*rsdp[i][1] + m6*rsdp[i][2]; + + pclist += 6; + } + } + + return; + } + + // ------------------------------------------------ + // build the off-diagonal elements of preconditioning matrix + // ------------------------------------------------ + + dpage_pcpc->reset(); + + // determine the off-diagonal elements of the preconditioner + + for (ii = 0; ii < inum; ii++) { + i = ilist[ii]; + itype = amtype[i]; + iclass = amtype2class[itype]; + igroup = amgroup[i]; + + jlist = firstneigh_precond[i]; + jnum = numneigh_precond[i]; + + xi = x[i][0]; + yi = x[i][1]; + zi = x[i][2]; + + poli = polarity[itype]; + if (amoeba) { + pdi = pdamp[itype]; + pti = thole[itype]; + } else if (hippo) { + corei = pcore[iclass]; + alphai = palpha[iclass]; + vali = pval[i]; + } + + // evaluate all sites in induce neigh list, no cutoff + // store results in plist for re-use in APPLY + + pclist = dpage_pcpc->get(6*jnum); + firstneigh_pcpc[i] = pclist; + + for (jj = 0; jj < jnum; jj++) { + j = jlist[jj]; + factor_wscale = special_polar_wscale[sbmask15(j)]; + j &= NEIGHMASK15; + + xr = x[j][0] - xi; + yr = x[j][1] - yi; + zr = x[j][2] - zi; + r2 = xr*xr + yr* yr + zr*zr; + r = sqrt(r2); + + jtype = amtype[j]; + jclass = amtype2class[jtype]; + jgroup = amgroup[j]; + + if (igroup == jgroup) factor_uscale = polar_uscale; + else factor_uscale = 1.0; + + if (amoeba) { + scale3 = factor_uscale; + scale5 = factor_uscale; + damp = pdi * pdamp[jtype]; + if (damp != 0.0) { + pgamma = MIN(pti,thole[jtype]); + damp = -pgamma * pow((r/damp),3.0); + if (damp > -50.0) { + expdamp = exp(damp); + scale3 *= 1.0 - expdamp; + scale5 *= 1.0 - expdamp*(1.0-damp); + } + } + } else if (hippo) { + corek = pcore[jclass]; + alphak = palpha[jclass]; + valk = pval[j]; + dampmut(r,alphai,alphak,dmpik); + scale3 = factor_wscale * dmpik[2]; + scale5 = factor_wscale * dmpik[4]; + } + + polik = poli * polarity[jtype]; + rr3 = scale3 * polik / (r*r2); + rr5 = 3.0 * scale5 * polik / (r*r2*r2); + + pclist[0] = rr5*xr*xr - rr3; + pclist[1] = rr5*xr*yr; + pclist[2] = rr5*xr*zr; + pclist[3] = rr5*yr*yr - rr3; + pclist[4] = rr5*yr*zr; + pclist[5] = rr5*zr*zr - rr3; + + // DEBUG + + /* + printf("PCLIST: ij %d %d: pc1-6 %g %g %g %g %g %g\n", + atom->tag[i],atom->tag[j], + pclist[0],pclist[1],pclist[2],pclist[3],pclist[4],pclist[5]); + printf(" AMOEBA: scale35 %g %g pdamp %g thole %g " + "pgamma %g facUscale %g damp %g\n", + scale3,scale5,pdamp[jtype],thole[jtype],pgamma,factor_uscale,damp); + */ + + pclist += 6; + } + } +} + +/* ---------------------------------------------------------------------- + dfield0c = direct induction via Ewald sum + dfield0c computes the mutual electrostatic field due to + permanent multipole moments via Ewald summation +------------------------------------------------------------------------- */ + +void PairAmoeba::dfield0c(double **field, double **fieldp) +{ + int i,j,ii; + double term; + + int inum; + int *ilist; + + // zero out field,fieldp for owned and ghost atoms + + int nlocal = atom->nlocal; + int nall = nlocal + atom->nghost; + + for (i = 0; i < nall; i++) { + for (j = 0; j < 3; j++) { + field[i][j] = 0.0; + fieldp[i][j] = 0.0; + } + } + + // get the reciprocal space part of the permanent field + + if (kspace_flag) udirect1(field); + + for (i = 0; i < nlocal; i++) { + for (j = 0; j < 3; j++) { + fieldp[i][j] = field[i][j]; + } + } + + // get the real space portion of the permanent field + + if (rspace_flag) udirect2b(field,fieldp); + + // get the self-energy portion of the permanent field + + term = (4.0/3.0) * aewald*aewald*aewald / MY_PIS; + for (i = 0; i < nlocal; i++) { + for (j = 0; j < 3; j++) { + field[i][j] += term*rpole[i][j+1]; + fieldp[i][j] += term*rpole[i][j+1]; + } + } +} + +/* ---------------------------------------------------------------------- + umutual1 = Ewald recip mutual induced field + umutual1 computes the reciprocal space contribution of the + induced atomic dipole moments to the field +------------------------------------------------------------------------- */ + +void PairAmoeba::umutual1(double **field, double **fieldp) +{ + int i,j,k,m,n; + int nxlo,nxhi,nylo,nyhi,nzlo,nzhi; + double term; + double a[3][3]; // indices not flipped vs Fortran + double **fuind,**fuinp; + double **fdip_phi1,**fdip_phi2,**fdip_sum_phi; + double **dipfield1,**dipfield2; + + // return if the Ewald coefficient is zero + + if (aewald < 1.0e-6) return; + + // perform dynamic allocation of some local arrays + // NOTE: avoid reallocation every step? + + int nlocal = atom->nlocal; + memory->create(fuind,nlocal,3,"ameoba/induce:fuind"); + memory->create(fuinp,nlocal,3,"ameoba/induce:fuinp"); + memory->create(fdip_phi1,nlocal,10,"ameoba/induce:fdip_phi1"); + memory->create(fdip_phi2,nlocal,10,"ameoba/induce:fdip_phi2"); + memory->create(fdip_sum_phi,nlocal,20,"ameoba/induce:fdip_dum_phi"); + memory->create(dipfield1,nlocal,3,"ameoba/induce:dipfield1"); + memory->create(dipfield2,nlocal,3,"ameoba/induce:dipfield2"); + + // convert Cartesian dipoles to fractional coordinates + + for (j = 0; j < 3; j++) { + a[0][j] = nfft1 * recip[0][j]; + a[1][j] = nfft2 * recip[1][j]; + a[2][j] = nfft3 * recip[2][j]; + } + + for (i = 0; i < nlocal; i++) { + for (j = 0; j < 3; j++) { + fuind[i][j] = a[j][0]*uind[i][0] + a[j][1]*uind[i][1] + a[j][2]*uind[i][2]; + fuinp[i][j] = a[j][0]*uinp[i][0] + a[j][1]*uinp[i][1] + a[j][2]*uinp[i][2]; + } + } + + /* + printf("fuind %g %g %g \n",fuind[0][0],fuind[0][1],fuind[0][2]); + printf("fuinp %g %g %g \n",fuinp[0][0],fuinp[0][1],fuinp[0][2]); + */ + + // gridpre = my portion of 4d grid in brick decomp w/ ghost values + + double ****gridpre = (double ****) ic_kspace->zero(); + + // map 2 values to grid + + grid_uind(fuind,fuinp,gridpre); + + // pre-convolution operations including forward FFT + // gridfft = my portion of complex 3d grid in FFT decomposition + + double *gridfft = ic_kspace->pre_convolution(); + + // --------------------- + // convolution operation + // --------------------- + + nxlo = ic_kspace->nxlo_fft; + nxhi = ic_kspace->nxhi_fft; + nylo = ic_kspace->nylo_fft; + nyhi = ic_kspace->nyhi_fft; + nzlo = ic_kspace->nzlo_fft; + nzhi = ic_kspace->nzhi_fft; + + // use qfac values stored in udirect1() + + m = n = 0; + for (k = nzlo; k <= nzhi; k++) { + for (j = nylo; j <= nyhi; j++) { + for (i = nxlo; i <= nxhi; i++) { + term = qfac[m++]; + gridfft[n] *= term; + gridfft[n+1] *= term; + n += 2; + } + } + } + + // post-convolution operations including backward FFT + // gridppost = my portion of 4d grid in brick decomp w/ ghost values + + double ****gridpost = (double ****) ic_kspace->post_convolution(); + + // get potential + + fphi_uind(gridpost,fdip_phi1,fdip_phi2,fdip_sum_phi); + + // printf ("fdip_phi1_uind %g %g %g %g %g %g %g %g %g %g\n", + // fdip_phi1[0][0], + // fdip_phi1[0][1],fdip_phi1[0][2],fdip_phi1[0][3],fdip_phi1[0][4],fdip_phi1[0][5], + // fdip_phi1[0][6],fdip_phi1[0][7],fdip_phi1[0][8],fdip_phi1[0][9],fdip_phi1[0][10]); + + // printf ("fdip_phi2_uind %g %g %g %g %g %g %g %g %g %g\n", + // fdip_phi2[0][0], + // fdip_phi2[0][1],fdip_phi2[0][2],fdip_phi2[0][3],fdip_phi2[0][4],fdip_phi2[0][5], + // fdip_phi2[0][6],fdip_phi2[0][7],fdip_phi2[0][8],fdip_phi2[0][9],fdip_phi2[0][10]); + + // store fractional reciprocal potentials for OPT method + + if (poltyp == OPT) { + for (i = 0; i < nlocal; i++) { + for (j = 0; j < 10; j++) { + fopt[i][optlevel][j] = fdip_phi1[i][j]; + foptp[i][optlevel][j] = fdip_phi2[i][j]; + } + } + } + + // convert the dipole fields from fractional to Cartesian + + for (i = 0; i < 3; i++) { + a[0][i] = nfft1 * recip[0][i]; + a[1][i] = nfft2 * recip[1][i]; + a[2][i] = nfft3 * recip[2][i]; + } + + for (i = 0; i < nlocal; i++) { + for (j = 0; j < 3; j++) { + dipfield1[i][j] = a[j][0]*fdip_phi1[i][1] + + a[j][1]*fdip_phi1[i][2] + a[j][2]*fdip_phi1[i][3]; + dipfield2[i][j] = a[j][0]*fdip_phi2[i][1] + + a[j][1]*fdip_phi2[i][2] + a[j][2]*fdip_phi2[i][3]; + } + } + + // increment the field at each multipole site + + for (i = 0; i < nlocal; i++) { + for (j = 0; j < 3; j++) { + field[i][j] -= dipfield1[i][j]; + fieldp[i][j] -= dipfield2[i][j]; + } + } + + // perform deallocation of some local arrays + + memory->destroy(fuind); + memory->destroy(fuinp); + memory->destroy(fdip_phi1); + memory->destroy(fdip_phi2); + memory->destroy(fdip_sum_phi); + memory->destroy(dipfield1); + memory->destroy(dipfield2); +} + +/* ---------------------------------------------------------------------- + umutual2b = Ewald real mutual field via list + umutual2b computes the real space contribution of the induced + atomic dipole moments to the field via a neighbor list +------------------------------------------------------------------------- */ + +void PairAmoeba::umutual2b(double **field, double **fieldp) +{ + int i,j,m,ii,jj,jnum; + double fid[3],fkd[3]; + double fip[3],fkp[3]; + double *uindi,*uindj,*uinpi,*uinpj; + + // neigh list + + int inum = list->inum; + int *ilist = list->ilist; + int *jlist; + double *tdipdip; + + // loop over owned atoms and neighs + // compute field terms for each pairwise interaction + // using tdipdip values stored by udirect2b() + + for (ii = 0; ii < inum; ii++) { + i = ilist[ii]; + uindi = uind[i]; + uinpi = uinp[i]; + jlist = firstneigh_dipole[i]; + tdipdip = firstneigh_dipdip[i]; + jnum = numneigh_dipole[i]; + + for (jj = 0; jj < jnum; jj++) { + j = jlist[jj]; + uindj = uind[j]; + uinpj = uinp[j]; + + fid[0] = tdipdip[0]*uindj[0] + tdipdip[1]*uindj[1] + tdipdip[2]*uindj[2]; + fid[1] = tdipdip[1]*uindj[0] + tdipdip[3]*uindj[1] + tdipdip[4]*uindj[2]; + fid[2] = tdipdip[2]*uindj[0] + tdipdip[4]*uindj[1] + tdipdip[5]*uindj[2]; + + fkd[0] = tdipdip[0]*uindi[0] + tdipdip[1]*uindi[1] + tdipdip[2]*uindi[2]; + fkd[1] = tdipdip[1]*uindi[0] + tdipdip[3]*uindi[1] + tdipdip[4]*uindi[2]; + fkd[2] = tdipdip[2]*uindi[0] + tdipdip[4]*uindi[1] + tdipdip[5]*uindi[2]; + + fip[0] = tdipdip[0]*uinpj[0] + tdipdip[1]*uinpj[1] + tdipdip[2]*uinpj[2]; + fip[1] = tdipdip[1]*uinpj[0] + tdipdip[3]*uinpj[1] + tdipdip[4]*uinpj[2]; + fip[2] = tdipdip[2]*uinpj[0] + tdipdip[4]*uinpj[1] + tdipdip[5]*uinpj[2]; + + fkp[0] = tdipdip[0]*uinpi[0] + tdipdip[1]*uinpi[1] + tdipdip[2]*uinpi[2]; + fkp[1] = tdipdip[1]*uinpi[0] + tdipdip[3]*uinpi[1] + tdipdip[4]*uinpi[2]; + fkp[2] = tdipdip[2]*uinpi[0] + tdipdip[4]*uinpi[1] + tdipdip[5]*uinpi[2]; + + // DEBUG + + /* + if (atom->tag[i] == 1 || atom->tag[j] == 1) { + printf ("TDIPDIP ij %d %d: tdd %g %g %g %g %g %g\n", + atom->tag[i],atom->tag[j], + tdipdip[0],tdipdip[1],tdipdip[2], + tdipdip[3],tdipdip[4],tdipdip[5]); + printf ("FIDFKD ij %d %d: fid %g %g %g fkd %g %g %g\n", + atom->tag[i],atom->tag[j], + fid[0],fid[1],fid[2], + fkd[0],fkd[1],fkd[2]); + } + */ + + tdipdip += 6; + + // increment the field at each site due to this interaction + + for (m = 0; m < 3; m++) { + field[i][m] += fid[m]; + field[j][m] += fkd[m]; + fieldp[i][m] += fip[m]; + fieldp[j][m] += fkp[m]; + } + } + } +} + +/* ---------------------------------------------------------------------- + udirect1 = Ewald recip direct induced field + udirect1 computes the reciprocal space contribution of the + permanent atomic multipole moments to the field + since corresponding values in empole and epolar are different +------------------------------------------------------------------------- */ + +void PairAmoeba::udirect1(double **field) +{ + int i,j,k,m,n; + int nhalf1,nhalf2,nhalf3; + int nxlo,nxhi,nylo,nyhi,nzlo,nzhi; + double r1,r2,r3; + double h1,h2,h3; + double volterm,denom; + double hsq,expterm; + double term,pterm; + + // return if the Ewald coefficient is zero + + if (aewald < 1.0e-6) return; + + pterm = (MY_PI/aewald) * (MY_PI/aewald); + double volbox = domain->prd[0] * domain->prd[1] * domain->prd[2]; + volterm = MY_PI * volbox; + + // perform dynamic allocation of 4 Cartesian and fractional arrays + // deallocate in polar + // NOTE: avoid reallocation every step? + + int nlocal = atom->nlocal; + memory->create(cmp,nlocal,10,"ameoba/induce:cmp"); + memory->create(fmp,nlocal,10,"ameoba/induce:fmp"); + memory->create(cphi,nlocal,10,"ameoba/induce:cphi"); + memory->create(fphi,nlocal,20,"ameoba/induce:fphi"); + + // FFT moduli pre-computations + // set igrid for each atom and its B-spline coeffs + + nfft1 = i_kspace->nx; + nfft2 = i_kspace->ny; + nfft3 = i_kspace->nz; + bsorder = i_kspace->order; + + moduli(); + bspline_fill(); + + // copy the multipole moments into local storage areas + + for (i = 0; i < nlocal; i++) { + cmp[i][0] = rpole[i][0]; + cmp[i][1] = rpole[i][1]; + cmp[i][2] = rpole[i][2]; + cmp[i][3] = rpole[i][3]; + cmp[i][4] = rpole[i][4]; + cmp[i][5] = rpole[i][8]; + cmp[i][6] = rpole[i][12]; + cmp[i][7] = 2.0 * rpole[i][5]; + cmp[i][8] = 2.0 * rpole[i][6]; + cmp[i][9] = 2.0 * rpole[i][9]; + } + + // convert Cartesian multipoles to fractional coordinates + + cmp_to_fmp(cmp,fmp); + + // gridpre = my portion of 3d grid in brick decomp w/ ghost values + // zeroed by setup() + + double ***gridpre = (double ***) i_kspace->zero(); + + // map multipole moments to grid + + grid_mpole(fmp,gridpre); + + // pre-convolution operations including forward FFT + // gridfft = my 1d portion of complex 3d grid in FFT decomp + + double *gridfft = i_kspace->pre_convolution(); + + // --------------------- + // convolution operation + // --------------------- + + nhalf1 = (nfft1+1) / 2; + nhalf2 = (nfft2+1) / 2; + nhalf3 = (nfft3+1) / 2; + + nxlo = i_kspace->nxlo_fft; + nxhi = i_kspace->nxhi_fft; + nylo = i_kspace->nylo_fft; + nyhi = i_kspace->nyhi_fft; + nzlo = i_kspace->nzlo_fft; + nzhi = i_kspace->nzhi_fft; + + m = n = 0; + for (k = nzlo; k <= nzhi; k++) { + for (j = nylo; j <= nyhi; j++) { + for (i = nxlo; i <= nxhi; i++) { + r1 = (i >= nhalf1) ? i-nfft1 : i; + r2 = (j >= nhalf2) ? j-nfft2 : j; + r3 = (k >= nhalf3) ? k-nfft3 : k; + h1 = recip[0][0]*r1 + recip[0][1]*r2 + recip[0][2]*r3; // matvec + h2 = recip[1][0]*r1 + recip[1][1]*r2 + recip[1][2]*r3; + h3 = recip[2][0]*r1 + recip[2][1]*r2 + recip[2][2]*r3; + hsq = h1*h1 + h2*h2 + h3*h3; + term = -pterm * hsq; + expterm = 0.0; + if (term > -50.0 && hsq != 0.0) { + denom = volterm*hsq*bsmod1[i]*bsmod2[j]*bsmod3[k]; + expterm = exp(term) / denom; + } + qfac[m++] = expterm; + gridfft[n] *= expterm; + gridfft[n+1] *= expterm; + n += 2; + } + } + } + + // post-convolution operations including backward FFT + // gridppost = my portion of 3d grid in brick decomp w/ ghost values + + double ***gridpost = (double ***) i_kspace->post_convolution(); + + // get potential + + fphi_mpole(gridpost,fphi); + + // printf ("fphi %g %g %g %g %g %g %g %g %g %g %g %g\n", + // fphi[1][1],fphi[1][2],fphi[1][3],fphi[1][4],fphi[1][5], + // fphi[1][6],fphi[1][7],fphi[1][8],fphi[1][9],fphi[1][10], + // fphi[1][11],fphi[1][12]); + + // convert the field from fractional to Cartesian + + fphi_to_cphi(fphi,cphi); + + // increment the field at each multipole site + + for (i = 0; i < nlocal; i++) { + field[i][0] -= cphi[i][1]; + field[i][1] -= cphi[i][2]; + field[i][2] -= cphi[i][3]; + } +} + +/* ---------------------------------------------------------------------- + udirect2b = Ewald real direct field via list + udirect2b computes the real space contribution of the permanent + atomic multipole moments to the field via a neighbor list +------------------------------------------------------------------------- */ + +void PairAmoeba::udirect2b(double **field, double **fieldp) +{ + int i,j,k,m,n,ii,jj,kk,kkk,jextra,ndip,itype,jtype,iclass,jclass,igroup,jgroup; + double xr,yr,zr,r,r2; + double rr1,rr2,rr3; + double rr5,rr7; + double rr3i,rr5i,rr7i; + double rr3k,rr5k,rr7k; + double rr3ik,rr5ik; + double bfac,exp2a; + double ci,dix,diy,diz; + double qixx,qiyy,qizz; + double qixy,qixz,qiyz; + double ck,dkx,dky,dkz; + double qkxx,qkyy,qkzz; + double qkxy,qkxz,qkyz; + double dir,dkr; + double qix,qiy,qiz,qir; + double qkx,qky,qkz,qkr; + double corei,corek; + double vali,valk; + double alphai,alphak; + double ralpha,aefac; + double aesq2,aesq2n; + double pdi,pti,ddi; + double pgamma; + double damp,expdamp; + double scale3,scale5; + double scale7,scalek; + double bn[4],bcn[3]; + double fid[3],fkd[3]; + double fip[3],fkp[3]; + double dmpi[7],dmpk[7]; + double dmpik[5]; + double factor_dscale,factor_pscale,factor_uscale,factor_wscale; + + int inum,jnum; + int *ilist,*jlist,*numneigh,**firstneigh; + + // owned atoms + + pval = atom->dvector[index_pval]; + + double **x = atom->x; + + // neigh list + + inum = list->inum; + ilist = list->ilist; + numneigh = list->numneigh; + firstneigh = list->firstneigh; + + // NOTE: doesn't this have a problem if aewald is tiny ?? + + aesq2 = 2.0 * aewald * aewald; + aesq2n = 0.0; + if (aewald > 0.0) aesq2n = 1.0 / (MY_PIS*aewald); + + // rebuild dipole-dipole pair list and store pairwise dipole matrices + // done one atom at a time in real-space double loop over atoms & neighs + + int *neighptr; + double *tdipdip; + + // compute the real space portion of the Ewald summation + + for (ii = 0; ii < inum; ii++) { + i = ilist[ii]; + itype = amtype[i]; + iclass = amtype2class[itype]; + igroup = amgroup[i]; + jlist = firstneigh[i]; + jnum = numneigh[i]; + + n = ndip = 0; + neighptr = ipage_dipole->vget(); + tdipdip = dpage_dipdip->vget(); + + ci = rpole[i][0]; + dix = rpole[i][1]; + diy = rpole[i][2]; + diz = rpole[i][3]; + qixx = rpole[i][4]; + qixy = rpole[i][5]; + qixz = rpole[i][6]; + qiyy = rpole[i][8]; + qiyz = rpole[i][9]; + qizz = rpole[i][12]; + if (amoeba) { + pdi = pdamp[itype]; + pti = thole[itype]; + ddi = dirdamp[itype]; + } else if (hippo) { + corei = pcore[iclass]; + alphai = palpha[iclass]; + vali = pval[i]; + } + + // DEBUG + + /* + if (atom->tag[i] == 4) { + printf("Atom 4 is in group %d\n",igroup); + printf("Atoms in same group:"); + for (int ig = 0; ig < atom->nlocal; ig++) + if (amgroup[ig] == igroup) printf(" %d",atom->tag[ig]); + printf("\n"); + } + */ + + // evaluate all sites within the cutoff distance + + for (jj = 0; jj < jnum; jj++) { + jextra = jlist[jj]; + j = jextra & NEIGHMASK15; + + xr = x[j][0] - x[i][0]; + yr = x[j][1] - x[i][1]; + zr = x[j][2] - x[i][2]; + r2 = xr*xr + yr* yr + zr*zr; + if (r2 > off2) continue; + + jtype = amtype[j]; + jclass = amtype2class[jtype]; + jgroup = amgroup[j]; + + if (amoeba) { + factor_wscale = special_polar_wscale[sbmask15(jextra)]; + if (igroup == jgroup) { + factor_pscale = special_polar_piscale[sbmask15(jextra)]; + factor_dscale = polar_dscale; + factor_uscale = polar_uscale; + } else { + factor_pscale = special_polar_pscale[sbmask15(jextra)]; + factor_dscale = factor_uscale = 1.0; + } + + } else if (hippo) { + factor_wscale = special_polar_wscale[sbmask15(jextra)]; + if (igroup == jgroup) { + factor_dscale = factor_pscale = special_polar_piscale[sbmask15(jextra)]; + factor_uscale = polar_uscale; + } else { + factor_dscale = factor_pscale = special_polar_pscale[sbmask15(jextra)]; + factor_uscale = 1.0; + } + } + + // DEBUG + + /* + if (atom->tag[i] == 4 || atom->tag[j] == 4) { + printf("PAIR ij %d %d ij group %d %d wpdu scale %g %g %g %g\n", + atom->tag[i],atom->tag[j],igroup,jgroup, + factor_wscale,factor_pscale,factor_dscale,factor_uscale); + } + */ + + r = sqrt(r2); + rr1 = 1.0 / r; + rr2 = rr1 * rr1; + rr3 = rr2 * rr1; + rr5 = 3.0 * rr2 * rr3; + rr7 = 5.0 * rr2 * rr5; + ck = rpole[j][0]; + dkx = rpole[j][1]; + dky = rpole[j][2]; + dkz = rpole[j][3]; + qkxx = rpole[j][4]; + qkxy = rpole[j][5]; + qkxz = rpole[j][6]; + qkyy = rpole[j][8]; + qkyz = rpole[j][9]; + qkzz = rpole[j][12]; + + // intermediates involving moments and separation distance + + dir = dix*xr + diy*yr + diz*zr; + qix = qixx*xr + qixy*yr + qixz*zr; + qiy = qixy*xr + qiyy*yr + qiyz*zr; + qiz = qixz*xr + qiyz*yr + qizz*zr; + qir = qix*xr + qiy*yr + qiz*zr; + dkr = dkx*xr + dky*yr + dkz*zr; + qkx = qkxx*xr + qkxy*yr + qkxz*zr; + qky = qkxy*xr + qkyy*yr + qkyz*zr; + qkz = qkxz*xr + qkyz*yr + qkzz*zr; + qkr = qkx*xr + qky*yr + qkz*zr; + + // calculate the real space Ewald error function terms + + ralpha = aewald * r; + bn[0] = erfc(ralpha) * rr1; + exp2a = exp(-ralpha*ralpha); + aefac = aesq2n; + for (m = 1; m <= 3; m++) { + bfac = m+m-1; + aefac = aesq2 * aefac; + bn[m] = (bfac*bn[m-1]+aefac*exp2a) * rr2; + } + + // find the field components for Thole polarization damping + + if (amoeba) { + scale3 = 1.0; + scale5 = 1.0; + scale7 = 1.0; + damp = pdi * pdamp[jtype]; + if (damp != 0.0) { + pgamma = MIN(ddi,dirdamp[jtype]); + if (pgamma != 0.0) { + damp = pgamma * pow(r/damp,1.5); + if (damp < 50.0) { + expdamp = exp(-damp) ; + scale3 = 1.0 - expdamp ; + scale5 = 1.0 - expdamp*(1.0+0.5*damp); + scale7 = 1.0 - expdamp*(1.0+0.65*damp + 0.15*damp*damp); + } + } else { + pgamma = MIN(pti,thole[jtype]); + damp = pgamma * pow(r/damp,3.0); + if (damp < 50.0) { + expdamp = exp(-damp); + scale3 = 1.0 - expdamp; + scale5 = 1.0 - expdamp*(1.0+damp); + scale7 = 1.0 - expdamp*(1.0+damp + 0.6*damp*damp); + } + } + } + + scalek = factor_dscale; + bcn[0] = bn[1] - (1.0-scalek*scale3)*rr3; + bcn[1] = bn[2] - (1.0-scalek*scale5)*rr5; + bcn[2] = bn[3] - (1.0-scalek*scale7)*rr7; + fid[0] = -xr*(bcn[0]*ck-bcn[1]*dkr+bcn[2]*qkr) - + bcn[0]*dkx + 2.0*bcn[1]*qkx; + fid[1] = -yr*(bcn[0]*ck-bcn[1]*dkr+bcn[2]*qkr) - + bcn[0]*dky + 2.0*bcn[1]*qky; + fid[2] = -zr*(bcn[0]*ck-bcn[1]*dkr+bcn[2]*qkr) - + bcn[0]*dkz + 2.0*bcn[1]*qkz; + fkd[0] = xr*(bcn[0]*ci+bcn[1]*dir+bcn[2]*qir) - + bcn[0]*dix - 2.0*bcn[1]*qix; + fkd[1] = yr*(bcn[0]*ci+bcn[1]*dir+bcn[2]*qir) - + bcn[0]*diy - 2.0*bcn[1]*qiy; + fkd[2] = zr*(bcn[0]*ci+bcn[1]*dir+bcn[2]*qir) - + bcn[0]*diz - 2.0*bcn[1]*qiz; + + scalek = factor_pscale; + bcn[0] = bn[1] - (1.0-scalek*scale3)*rr3; + bcn[1] = bn[2] - (1.0-scalek*scale5)*rr5; + bcn[2] = bn[3] - (1.0-scalek*scale7)*rr7; + fip[0] = -xr*(bcn[0]*ck-bcn[1]*dkr+bcn[2]*qkr) - + bcn[0]*dkx + 2.0*bcn[1]*qkx; + fip[1] = -yr*(bcn[0]*ck-bcn[1]*dkr+bcn[2]*qkr) - + bcn[0]*dky + 2.0*bcn[1]*qky; + fip[2] = -zr*(bcn[0]*ck-bcn[1]*dkr+bcn[2]*qkr) - + bcn[0]*dkz + 2.0*bcn[1]*qkz; + fkp[0] = xr*(bcn[0]*ci+bcn[1]*dir+bcn[2]*qir) - + bcn[0]*dix - 2.0*bcn[1]*qix; + fkp[1] = yr*(bcn[0]*ci+bcn[1]*dir+bcn[2]*qir) - + bcn[0]*diy - 2.0*bcn[1]*qiy; + fkp[2] = zr*(bcn[0]*ci+bcn[1]*dir+bcn[2]*qir) - + bcn[0]*diz - 2.0*bcn[1]*qiz; + + // find terms needed later to compute mutual polarization + + if (poltyp != DIRECT) { + scale3 = 1.0; + scale5 = 1.0; + damp = pdi * pdamp[jtype]; + if (damp != 0.0) { + pgamma = MIN(pti,thole[jtype]); + damp = pgamma * pow(r/damp,3.0); + if (damp < 50.0) { + expdamp = exp(-damp); + scale3 = 1.0 - expdamp; + scale5 = 1.0 - expdamp*(1.0+damp); + } + } + scalek = factor_uscale; + bcn[0] = bn[1] - (1.0-scalek*scale3)*rr3; + bcn[1] = bn[2] - (1.0-scalek*scale5)*rr5; + + neighptr[n++] = j; + tdipdip[ndip++] = -bcn[0] + bcn[1]*xr*xr; + tdipdip[ndip++] = bcn[1]*xr*yr; + tdipdip[ndip++] = bcn[1]*xr*zr; + tdipdip[ndip++] = -bcn[0] + bcn[1]*yr*yr; + tdipdip[ndip++] = bcn[1]*yr*zr; + tdipdip[ndip++] = -bcn[0] + bcn[1]*zr*zr; + } + + // find the field components for charge penetration damping + + } else if (hippo) { + corek = pcore[jclass]; + alphak = palpha[jclass]; + valk = pval[j]; + dampdir(r,alphai,alphak,dmpi,dmpk); + + scalek = factor_dscale; + rr3i = bn[1] - (1.0-scalek*dmpi[2])*rr3; + rr5i = bn[2] - (1.0-scalek*dmpi[4])*rr5; + rr7i = bn[3] - (1.0-scalek*dmpi[6])*rr7; + rr3k = bn[1] - (1.0-scalek*dmpk[2])*rr3; + rr5k = bn[2] - (1.0-scalek*dmpk[4])*rr5; + rr7k = bn[3] - (1.0-scalek*dmpk[6])*rr7; + rr3 = bn[1] - (1.0-scalek)*rr3; + fid[0] = -xr*(rr3*corek + rr3k*valk - rr5k*dkr + rr7k*qkr) - + rr3k*dkx + 2.0*rr5k*qkx; + fid[1] = -yr*(rr3*corek + rr3k*valk - rr5k*dkr + rr7k*qkr) - + rr3k*dky + 2.0*rr5k*qky; + fid[2] = -zr*(rr3*corek + rr3k*valk - rr5k*dkr + rr7k*qkr) - + rr3k*dkz + 2.0*rr5k*qkz; + fkd[0] = xr*(rr3*corei + rr3i*vali + rr5i*dir + rr7i*qir) - + rr3i*dix - 2.0*rr5i*qix; + fkd[1] = yr*(rr3*corei + rr3i*vali + rr5i*dir + rr7i*qir) - + rr3i*diy - 2.0*rr5i*qiy; + fkd[2] = zr*(rr3*corei + rr3i*vali + rr5i*dir + rr7i*qir) - + rr3i*diz - 2.0*rr5i*qiz; + + scalek = factor_pscale; + rr3 = rr2 * rr1; + rr3i = bn[1] - (1.0-scalek*dmpi[2])*rr3; + rr5i = bn[2] - (1.0-scalek*dmpi[4])*rr5; + rr7i = bn[3] - (1.0-scalek*dmpi[6])*rr7; + rr3k = bn[1] - (1.0-scalek*dmpk[2])*rr3; + rr5k = bn[2] - (1.0-scalek*dmpk[4])*rr5; + rr7k = bn[3] - (1.0-scalek*dmpk[6])*rr7; + rr3 = bn[1] - (1.0-scalek)*rr3; + fip[0] = -xr*(rr3*corek + rr3k*valk - rr5k*dkr + rr7k*qkr) - + rr3k*dkx + 2.0*rr5k*qkx; + fip[1] = -yr*(rr3*corek + rr3k*valk - rr5k*dkr + rr7k*qkr) - + rr3k*dky + 2.0*rr5k*qky; + fip[2] = -zr*(rr3*corek + rr3k*valk - rr5k*dkr + rr7k*qkr) - + rr3k*dkz + 2.0*rr5k*qkz; + fkp[0] = xr*(rr3*corei + rr3i*vali + rr5i*dir + rr7i*qir) - + rr3i*dix - 2.0*rr5i*qix; + fkp[1] = yr*(rr3*corei + rr3i*vali + rr5i*dir + rr7i*qir) - + rr3i*diy - 2.0*rr5i*qiy; + fkp[2] = zr*(rr3*corei + rr3i*vali + rr5i*dir + rr7i*qir) - + rr3i*diz - 2.0*rr5i*qiz; + + // find terms needed later to compute mutual polarization + + if (poltyp != DIRECT) { + dampmut(r,alphai,alphak,dmpik); + scalek = factor_wscale; + rr3 = rr2 * rr1; + rr3ik = bn[1] - (1.0-scalek*dmpik[2])*rr3; + rr5ik = bn[2] - (1.0-scalek*dmpik[4])*rr5; + + // DEBUG + + /* + if (atom->tag[i] == 1 || atom->tag[j] == 1) + printf ("DAMPMUT ij %d %d: bn12 %g %g dmpik-01234 %g %g %g %g %g\n", + atom->tag[i],atom->tag[j], + bn[1],bn[2], + dmpik[0],dmpik[1],dmpik[2],dmpik[3],dmpik[4]); + */ + + neighptr[n++] = j; + tdipdip[ndip++] = -rr3ik + rr5ik*xr*xr; + tdipdip[ndip++] = rr5ik*xr*yr; + tdipdip[ndip++] = rr5ik*xr*zr; + tdipdip[ndip++] = -rr3ik + rr5ik*yr*yr; + tdipdip[ndip++] = rr5ik*yr*zr; + tdipdip[ndip++] = -rr3ik + rr5ik*zr*zr; + } + } + + // increment the field at each site due to this interaction + + for (m = 0; m < 3; m++) { + field[i][m] += fid[m]; + field[j][m] += fkd[m]; + fieldp[i][m] += fip[m]; + fieldp[j][m] += fkp[m]; + } + } + + firstneigh_dipole[i] = neighptr; + firstneigh_dipdip[i] = tdipdip; + numneigh_dipole[i] = n; + ipage_dipole->vgot(n); + dpage_dipdip->vgot(ndip); + } +} + +/* ---------------------------------------------------------------------- + dampmut = mutual field damping coefficents + dampmut generates coefficients for the mutual field damping + function for powers of the interatomic distance +------------------------------------------------------------------------- */ + +void PairAmoeba::dampmut(double r, double alphai, double alphak, double *dmpik) +{ + double termi,termk; + double termi2,termk2; + double alphai2,alphak2; + double eps,diff; + double expi,expk; + double dampi,dampk; + double dampi2,dampi3; + double dampi4,dampi5; + double dampk2,dampk3; + + // compute tolerance and exponential damping factors + + eps = 0.001; + diff = fabs(alphai-alphak); + dampi = alphai * r; + dampk = alphak * r; + expi = exp(-dampi); + expk = exp(-dampk); + + // valence-valence charge penetration damping for Gordon f1 (HIPPO) + + dampi2 = dampi * dampi; + dampi3 = dampi * dampi2; + if (diff < eps) { + dampi4 = dampi2 * dampi2; + dampi5 = dampi2 * dampi3; + dmpik[2] = 1.0 - (1.0 + dampi + 0.5*dampi2 + + 7.0*dampi3/48.0 + dampi4/48.0)*expi; + dmpik[4] = 1.0 - (1.0 + dampi + 0.5*dampi2 + dampi3/6.0 + + dampi4/24.0 + dampi5/144.0)*expi; + } else { + dampk2 = dampk * dampk; + dampk3 = dampk * dampk2; + alphai2 = alphai * alphai; + alphak2 = alphak * alphak; + termi = alphak2 / (alphak2-alphai2); + termk = alphai2 / (alphai2-alphak2); + termi2 = termi * termi; + termk2 = termk * termk; + dmpik[2] = 1.0 - termi2*(1.0+dampi+0.5*dampi2)*expi - + termk2*(1.0+dampk+0.5*dampk2)*expk - + 2.0*termi2*termk*(1.0+dampi)*expi - 2.0*termk2*termi*(1.0+dampk)*expk; + dmpik[4] = 1.0 - termi2*(1.0+dampi+0.5*dampi2 + dampi3/6.0)*expi - + termk2*(1.0+dampk+0.5*dampk2 + dampk3/6.00)*expk - + 2.0*termi2*termk *(1.0+dampi+dampi2/3.0)*expi - + 2.0*termk2*termi *(1.0+dampk+dampk2/3.0)*expk; + } +} + +/* ---------------------------------------------------------------------- + dampdir = direct field damping coefficents + dampdir generates coefficients for the direct field damping + function for powers of the interatomic distance +------------------------------------------------------------------------- */ + +void PairAmoeba::dampdir(double r, double alphai, double alphak, + double *dmpi, double *dmpk) +{ + double eps,diff; + double expi,expk; + double dampi,dampk; + double dampi2,dampk2; + double dampi3,dampk3; + double dampi4,dampk4; + + // compute tolerance and exponential damping factors + + eps = 0.001; + diff = fabs(alphai-alphak); + dampi = alphai * r; + dampk = alphak * r; + expi = exp(-dampi); + expk = exp(-dampk); + + // core-valence charge penetration damping for Gordon f1 (HIPPO) + + dampi2 = dampi * dampi; + dampi3 = dampi * dampi2; + dampi4 = dampi2 * dampi2; + dmpi[2] = 1.0 - (1.0 + dampi + 0.5*dampi2)*expi; + dmpi[4] = 1.0 - (1.0 + dampi + 0.5*dampi2 + dampi3/6.0)*expi; + dmpi[6] = 1.0 - (1.0 + dampi + 0.5*dampi2 + dampi3/6.0 + dampi4/30.0)*expi; + if (diff < eps) { + dmpk[2] = dmpi[2]; + dmpk[4] = dmpi[4]; + dmpk[6] = dmpi[6]; + } else { + dampk2 = dampk * dampk; + dampk3 = dampk * dampk2; + dampk4 = dampk2 * dampk2; + dmpk[2] = 1.0 - (1.0 + dampk + 0.5*dampk2)*expk; + dmpk[4] = 1.0 - (1.0 + dampk + 0.5*dampk2 + dampk3/6.0)*expk; + dmpk[6] = 1.0 - (1.0 + dampk + 0.5*dampk2 + dampk3/6.0 + dampk4/30.0)*expk; + } +} + +/* ---------------------------------------------------------------------- + cholesky = modified Cholesky linear solver + cholesky uses a modified Cholesky method to solve the linear + system Ax = b, returning "x" in "b"; "A" is a real symmetric + positive definite matrix with its upper triangle (including the + diagonal) stored by rows + literature reference: + R. S. Martin, G. Peters and J. H. Wilkinson, "Symmetric + Decomposition of a Positive Definite Matrix", Numerische + Mathematik, 7, 362-383 (1965) +------------------------------------------------------------------------- */ + +void PairAmoeba::cholesky(int nvar, double *a, double *b) +{ + int i,j,k; + int ii,ij,ik,ki,kk; + int im,jk,jm; + double r,s,t; + + // all code in this method is exact translation from Fortran version + // decrement pointers so can access vectors like Fortran does from 1:N + + a--; + b--; + + // Cholesky factorization to reduce A to (L)(D)(L transpose) + // L has a unit diagonal; store 1.0/D on the diagonal of A + + ii = 1; + for (i = 1; i <= nvar; i++) { + im = i - 1; + if (i != 1) { + ij = i; + for (j = 1; j <= im; j++) { + r = a[ij]; + if (j != 1) { + ik = i; + jk = j; + jm = j - 1; + for (k = 1; k <= jm; k++) { + r = r - a[ik]*a[jk]; + ik = nvar - k + ik; + jk = nvar - k + jk; + } + } + a[ij] = r; + ij = nvar - j + ij; + } + } + + r = a[ii]; + if (i != 1) { + kk = 1; + ik = i; + for (k = 1; k <= im; k++) { + s = a[ik]; + t = s * a[kk]; + a[ik] = t; + r = r - s*t; + ik = nvar - k + ik; + kk = nvar - k + 1 + kk; + } + } + + a[ii] = 1.0 / r; + ii = nvar - i + 1 + ii; + } + + // solve linear equations; first solve Ly = b for y + + for (i = 1; i <= nvar; i++) { + if (i != 1) { + ik = i; + im = i - 1; + r = b[i]; + for (k = 1; k <= im; k++) { + r = r - b[k]*a[ik]; + ik = nvar - k + ik; + } + b[i] = r; + } + } + + // finally, solve (D)(L transpose)(x) = y for x + + ii = nvar*(nvar+1)/2; + for (j = 1; j <= nvar; j++) { + i = nvar + 1 - j; + r = b[i] * a[ii]; + if (j != 1) { + im = i + 1; + ki = ii + 1; + for (k = im; k <= nvar; k++) { + r = r - a[ki]*b[k]; + ki = ki + 1; + } + } + b[i] = r; + ii = ii - j - 1; + } +} diff --git a/src/AMOEBA/amoeba_kspace.cpp b/src/AMOEBA/amoeba_kspace.cpp new file mode 100644 index 0000000000..b73ff8e018 --- /dev/null +++ b/src/AMOEBA/amoeba_kspace.cpp @@ -0,0 +1,1241 @@ +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#include "pair_amoeba.h" +#include +#include "atom.h" +#include "domain.h" +#include "math_const.h" +#include "memory.h" + +using namespace LAMMPS_NS; +using namespace MathConst; + +#define ANINT(x) ((x)>0 ? floor((x)+0.5) : ceil((x)-0.5)) + +/* ---------------------------------------------------------------------- + lattice = setup periodic boundary conditions + lattice stores the periodic box dimensions and sets angle + values to be used in computing fractional coordinates +------------------------------------------------------------------------- */ + +void PairAmoeba::lattice() +{ + recip[0][0] = recip[0][1] = recip[0][2] = 0.0; + recip[1][0] = recip[1][1] = recip[1][2] = 0.0; + recip[2][0] = recip[2][1] = recip[2][2] = 0.0; + + double *h_inv = domain->h_inv; + + recip[0][0] = h_inv[0]; + recip[1][1] = h_inv[1]; + recip[2][2] = h_inv[2]; + + if (domain->triclinic) { + recip[1][0] = h_inv[5]; + recip[2][0] = h_inv[4]; + recip[2][1] = h_inv[3]; + } +} + +/* ---------------------------------------------------------------------- + moduli = store the inverse DFT moduli + moduli sets the moduli of the inverse discrete Fourier transform of the B-splines +------------------------------------------------------------------------- */ + +void PairAmoeba::moduli() +{ + int i; + + // perform dynamic allocation of local arrays + + int maxfft = MAX(nfft1,nfft2); + maxfft = MAX(maxfft,nfft3); + + double *array = new double[bsorder]; + double *bsarray = new double[maxfft]; + + // compute and load the moduli values + + double x = 0.0; + bspline(x,bsorder,array); + //printf("AAA array %f %f %f %f \n",array[0],array[1],array[2],array[3]); + + for (i = 0; i < maxfft; i++) bsarray[i] = 0.0; + for (i = 0; i < bsorder; i++) bsarray[i+1] = array[i]; + + dftmod(bsmod1,bsarray,nfft1,bsorder); + dftmod(bsmod2,bsarray,nfft2,bsorder); + dftmod(bsmod3,bsarray,nfft3,bsorder); + + // perform deallocation of local arrays + + delete [] array; + delete [] bsarray; +} + +/* ---------------------------------------------------------------------- + bspline = determine B-spline coefficients + bspline calculates the coefficients for an n-th order B-spline approximation +------------------------------------------------------------------------- */ + +void PairAmoeba::bspline(double x, int n, double *c) +{ + int i,k; + double denom; + + // initialize the B-spline as the linear case + + c[0] = 1.0 - x; + c[1] = x; + + // compute standard B-spline recursion to n-th order + + /*for (k = 2; k < n; k++) { + denom = 1.0 / (k-1); + c[k] = x * c[k-1] * denom; + for (i = 0; i < k-1; i++) + c[k-i] = ((x+i)*c[k-i-1] + (k-i-x)*c[k-i]) * denom; + c[0] = (1.0-x) * c[0] * denom; + }*/ + + for (k = 3; k <= n; k++) { + denom = 1.0 / (k-1); + c[k-1] = x * c[k-2] * denom; + for (i = 1; i <= k-2; i++) + c[k-i-1] = ((x+i)*c[k-i-2] + (k-i-x)*c[k-i-1]) * denom; + c[0] = (1.0-x) * c[0] * denom; + } + +} + +/* ---------------------------------------------------------------------- + dftmod = discrete Fourier transform modulus + dftmod computes the modulus of the discrete Fourier transform + of bsarray and stores it in bsmod +------------------------------------------------------------------------- */ + +void PairAmoeba::dftmod(double *bsmod, double *bsarray, int nfft, int order) +{ + int i,j,k; + int jcut; + int order2; + double eps,zeta; + double arg,factor; + double sum1,sum2; + + // get the modulus of the discrete Fourier transform + + factor = 2.0 * MY_PI / nfft; + for (i = 0; i < nfft; i++) { + sum1 = 0.0; + sum2 = 0.0; + for (j = 0; j < nfft; j++) { + arg = factor*i*j; + sum1 += bsarray[j]*cos(arg); + sum2 += bsarray[j]*sin(arg); + } + bsmod[i] = sum1*sum1 + sum2*sum2; + //printf("BSMOD AAA i %d bsmod %g\n",i,bsmod[i]); + } + + // fix for exponential Euler spline interpolation failure + + eps = 1.0e-7; + if (bsmod[0] < eps) bsmod[0] = 0.5 * bsmod[1]; + for (i = 1; i < nfft-1; i++) + if (bsmod[i] < eps) bsmod[i] = 0.5 * (bsmod[i-1] + bsmod[i+1]); + if (bsmod[nfft-1] < eps) bsmod[nfft-1] = 0.5 * bsmod[nfft-2]; + + // compute and apply the optimal zeta coefficient + + jcut = 50; + order2 = 2 * order; + for (i = 1; i <= nfft; i++) { + k = i - 1; + if (i > nfft/2) k -= nfft; + if (k == 0) zeta = 1.0; + else { + sum1 = 1.0; + sum2 = 1.0; + factor = MY_PI * k / nfft; + for (j = 1; j <= jcut; j++) { + arg = factor / (factor + MY_PI*j); + sum1 += pow(arg,order); + sum2 += pow(arg,order2); + } + for (j = 1; j <= jcut; j++) { + arg = factor / (factor - MY_PI*j); + sum1 += pow(arg,order); + sum2 += pow(arg,order2); + } + zeta = sum2 / sum1; + } + bsmod[i-1] *= zeta*zeta; + } +} + +/* ---------------------------------------------------------------------- + bspline_fill = get PME B-spline coefficients + bspline_fill finds B-spline coefficients and derivatives + for PME atomic sites along the fractional coordinate axes +------------------------------------------------------------------------- */ + +void PairAmoeba::bspline_fill() +{ + int i,ifr; + double xi,yi,zi; + double w,fr,eps; + double lamda[3]; + + int nlocal = atom->nlocal; + double **x = atom->x; + + // offset used to shift sites off exact lattice bounds + + eps = 1.0e-8; + + // get the B-spline coefficients for each atomic site + + for (int i = 0; i < nlocal; i++) { + + // NOTE: what about offset/shift and w < 0 or w > 1 + // NOTE: this is place to check that stencil size does not + // go out of bounds relative to igrid for a proc's sub-domain + // NOTE: could convert x -> lamda for entire set of Nlocal atoms + + domain->x2lamda(x[i],lamda); + + w = lamda[0]; + fr = nfft1 * w; + ifr = static_cast (fr-eps); + w = fr - ifr; + igrid[i][0] = ifr; + //igrid[i][0] = ifr + 1; // NOTE: could subtract off nlpts to start with + //if (igrid[i][0] == nfft1) igrid[i][0] = 0; + bsplgen(w,thetai1[i]); + + w = lamda[1]; + fr = nfft2 * w; + ifr = static_cast (fr-eps); + w = fr - ifr; + igrid[i][1] = ifr; + //igrid[i][1] = ifr + 1; + //if (igrid[i][1] == nfft2) igrid[i][1] = 0; + bsplgen(w,thetai2[i]); + + w = lamda[2]; + fr = nfft3 * w; + ifr = static_cast (fr-eps); + w = fr - ifr; + igrid[i][2] = ifr; + //igrid[i][2] = ifr + 1; + //if (igrid[i][2] == nfft3) igrid[i][2] = 0; + bsplgen(w,thetai3[i]); + } +} + +/* ---------------------------------------------------------------------- + bsplgen = B-spline coefficients for an atom + bsplgen gets B-spline coefficients and derivatives for + a single PME atomic site along a particular direction +------------------------------------------------------------------------- */ + +void PairAmoeba::bsplgen(double w, double **thetai) +{ + int i,j,k; + int level; + double denom; + + level = 4; + + // initialization to get to 2nd order recursion + + bsbuild[1][1] = w; + bsbuild[0][1] = 1.0 - w; + + // perform one pass to get to 3rd order recursion + + bsbuild[2][2] = 0.5 * w * bsbuild[1][1]; + bsbuild[1][2] = 0.5 * ((1.0+w)*bsbuild[0][1] + (2.0-w)*bsbuild[1][1]); + bsbuild[0][2] = 0.5 * (1.0-w) * bsbuild[0][1]; + + // compute standard B-spline recursion to desired order + + for (i = 4; i <= bsorder; i++) { + k = i - 1; + denom = 1.0 / k; + bsbuild[i-1][i-1] = denom * w * bsbuild[k-1][k-1]; + for (j = 1; j <= i-2; j++) { + bsbuild[i-j-1][i-1] = denom * + ((w+j)*bsbuild[i-j-2][k-1] + (i-j-w)*bsbuild[i-j-1][k-1]); + } + bsbuild[0][i-1] = denom * (1.0-w) * bsbuild[0][k-1]; + } + + // get coefficients for the B-spline first derivative + + k = bsorder - 1; + bsbuild[bsorder-1][k-1] = bsbuild[bsorder-2][k-1]; + for (int i = bsorder-1; i >= 2; i--) + bsbuild[i-1][k-1] = bsbuild[i-2][k-1] - bsbuild[i-1][k-1]; + bsbuild[0][k-1] = -bsbuild[0][k-1]; + + // get coefficients for the B-spline second derivative + + if (level == 4) { + k = bsorder - 2; + bsbuild[bsorder-2][k-1] = bsbuild[bsorder-3][k-1]; + for (int i = bsorder-2; i >= 2; i--) + bsbuild[i-1][k-1] = bsbuild[i-2][k-1] - bsbuild[i-1][k-1]; + bsbuild[0][k-1] = -bsbuild[0][k-1]; + bsbuild[bsorder-1][k-1] = bsbuild[bsorder-2][k-1]; + for (int i = bsorder-1; i >= 2; i--) + bsbuild[i-1][k-1] = bsbuild[i-2][k-1] - bsbuild[i-1][k-1]; + bsbuild[0][k-1] = -bsbuild[0][k-1]; + + // get coefficients for the B-spline third derivative + + k = bsorder - 3; + bsbuild[bsorder-3][k-1] = bsbuild[bsorder-4][k-1]; + for (int i = bsorder-3; i >= 2; i--) + bsbuild[i-1][k-1] = bsbuild[i-2][k-1] - bsbuild[i-1][k-1]; + bsbuild[0][k-1] = -bsbuild[0][k-1]; + bsbuild[bsorder-2][k-1] = bsbuild[bsorder-3][k-1]; + for (int i = bsorder-2; i >= 2; i--) + bsbuild[i-1][k-1] = bsbuild[i-2][k-1] - bsbuild[i-1][k-1]; + bsbuild[0][k-1] = -bsbuild[0][k-1]; + bsbuild[bsorder-1][k-1] = bsbuild[bsorder-2][k-1]; + for (int i = bsorder-1; i >= 2; i--) + bsbuild[i-1][k-1] = bsbuild[i-2][k-1] - bsbuild[i-1][k-1]; + bsbuild[0][k-1] = -bsbuild[0][k-1]; + } + + // copy coefficients from temporary to permanent storage + + for (int i = 1; i <= bsorder; i++) + for (int j = 1; j <= level; j++) + thetai[i-1][j-1] = bsbuild[i-1][bsorder-j]; +} + +/* ---------------------------------------------------------------------- + cmp_to_fmp = transformation of multipoles + cmp_to_fmp transforms the atomic multipoles from Cartesian + to fractional coordinates +------------------------------------------------------------------------- */ + +void PairAmoeba::cmp_to_fmp(double **cmp, double **fmp) +{ + int i,j,k; + + // find the matrix to convert Cartesian to fractional + + cart_to_frac(); + + // apply the transformation to get the fractional multipoles + + int nlocal = atom->nlocal; + + for (i = 0; i < nlocal; i++) { + fmp[i][0] = ctf[0][0] * cmp[i][0]; + for (j = 1; j < 4; j++) { + fmp[i][j] = 0.0; + for (k = 1; k < 4; k++) + fmp[i][j] += ctf[j][k] * cmp[i][k]; + } + for (j = 4; j < 10; j++) { + fmp[i][j] = 0.0; + /*for (k = 5; k < 10; k++)*/ + for (k = 4; k < 10; k++) + fmp[i][j] += ctf[j][k] * cmp[i][k]; + } + } +} + +/* ---------------------------------------------------------------------- + cart_to_frac = Cartesian to fractional + cart_to_frac computes a transformation matrix to convert + a multipole object in Cartesian coordinates to fractional + note the multipole components are stored in the condensed + order (m,dx,dy,dz,qxx,qyy,qzz,qxy,qxz,qyz) +------------------------------------------------------------------------- */ + +void PairAmoeba::cart_to_frac() +{ + int i,j,k,m,i1,i2; + int qi1[6] = {0,1,2,0,0,1}; // decremented vs Fortran + int qi2[6] = {0,1,2,1,2,2}; // decremented vs Fortran + double a[3][3]; // indices not flipped vs Fortran + + // set the reciprocal vector transformation matrix + + for (i = 0; i < 3; i++) { + a[0][i] = nfft1 * recip[i][0]; + a[1][i] = nfft2 * recip[i][1]; + a[2][i] = nfft3 * recip[i][2]; + } + + // get the Cartesian to fractional conversion matrix + + for (i = 0; i < 10; i++) + for (j = 0; j < 10; j++) + ctf[i][j] = 0.0; + + ctf[0][0] = 1.0; + for (i = 1; i < 4; i++) + for (j = 1; j < 4; j++) + ctf[i][j] = a[i-1][j-1]; + + for (i1 = 0; i1 < 3; i1++) { + k = qi1[i1]; + for (i2 = 0; i2 < 6; i2++) { + i = qi1[i2]; + j = qi2[i2]; + ctf[i1+4][i2+4] = a[k][i] * a[k][j]; + } + } + + for (i1 = 3; i1 < 6; i1++) { + k = qi1[i1]; + m = qi2[i1]; + for (i2 = 0; i2 < 6; i2++) { + i = qi1[i2]; + j = qi2[i2]; + ctf[i1+4][i2+4] = a[k][i]*a[m][j] + a[k][j]*a[m][i]; + } + } +} + +/* ---------------------------------------------------------------------- + fphi_to_cphi = transformation of potential + fphi_to_cphi transforms the reciprocal space potential from + fractional to Cartesian coordinates +------------------------------------------------------------------------- */ + +void PairAmoeba::fphi_to_cphi(double **fphi, double **cphi) +{ + int i,j,k; + + // find the matrix to convert fractional to Cartesian + + frac_to_cart(); + + // apply the transformation to get the Cartesian potential + + int nlocal = atom->nlocal; + + for (i = 0; i < nlocal; i++) { + cphi[i][0] = ftc[0][0] * fphi[i][0]; + for (j = 1; j < 4; j++) { + cphi[i][j] = 0.0; + for (k = 1; k < 4; k++) + cphi[i][j] += ftc[j][k] * fphi[i][k]; + } + for (j = 4; j < 10; j++) { + cphi[i][j] = 0.0; + for (k = 4; k < 10; k++) + cphi[i][j] += ftc[j][k] * fphi[i][k]; + } + } +} + +/* ---------------------------------------------------------------------- + frac_to_cart = fractional to Cartesian + frac_to_cart computes a transformation matrix to convert + a multipole object in fraction coordinates to Cartesian + note the multipole components are stored in the condensed + order (m,dx,dy,dz,qxx,qyy,qzz,qxy,qxz,qyz) +------------------------------------------------------------------------- */ + +void PairAmoeba::frac_to_cart() +{ + int i,j,k,m,i1,i2; + int qi1[6] = {0,1,2,0,0,1}; // decremented vs Fortran + int qi2[6] = {0,1,2,1,2,2}; // decremented vs Fortran + double a[3][3]; // indices not flipped vs Fortran + + // set the reciprocal vector transformation matrix + + for (i = 0; i < 3; i++) { + a[i][0] = nfft1 * recip[i][0]; + a[i][1] = nfft2 * recip[i][1]; + a[i][2] = nfft3 * recip[i][2]; + } + + // get the fractional to Cartesian conversion matrix + + for (i = 0; i < 10; i++) + for (j = 0; j < 10; j++) + ftc[i][j] = 0.0; + + ftc[0][0] = 1.0; + for (i = 1; i < 4; i++) + for (j = 1; j < 4; j++) + ftc[i][j] = a[i-1][j-1]; + + for (i1 = 0; i1 < 3; i1++) { + k = qi1[i1]; + for (i2 = 0; i2 < 3; i2++) { + i = qi1[i2]; + ftc[i1+4][i2+4] = a[k][i] * a[k][i]; + } + for (i2 = 3; i2 < 6; i2++) { + i = qi1[i2]; + j = qi2[i2]; + ftc[i1+4][i2+4] = 2.0 * a[k][i] * a[k][j]; + } + } + + for (i1 = 3; i1 < 6; i1++) { + k = qi1[i1]; + m = qi2[i1]; + for (i2 = 0; i2 < 3; i2++) { + i = qi1[i2]; + ftc[i1+4][i2+4] = a[k][i] * a[m][i]; + } + for (i2 = 3; i2 < 6; i2++) { + i = qi1[i2]; + j = qi2[i2]; + ftc[i1+4][i2+4] = a[k][i]*a[m][j] + a[m][i]*a[k][j]; + } + } +} + +/* ---------------------------------------------------------------------- + grid_mpole = put multipoles on PME grid + grid_mpole maps fractional atomic multipoles to PME grid +------------------------------------------------------------------------- */ + +void PairAmoeba::grid_mpole(double **fmp, double ***grid) +{ + int i,j,k,m,ib,jb,kb; + double v0,u0,t0; + double v1,u1,t1; + double v2,u2,t2; + double term0,term1,term2; + + int nlpts = (bsorder-1) / 2; + int nrpts = bsorder - nlpts - 1; + + // spread the permanent multipole moments onto the grid + + int nlocal = atom->nlocal; + + for (m = 0; m < nlocal; m++) { + + k = igrid[m][2] - nlpts; + for (kb = 0; kb < bsorder; kb++) { + v0 = thetai3[m][kb][0]; + v1 = thetai3[m][kb][1]; + v2 = thetai3[m][kb][2]; + + j = igrid[m][1] - nlpts; + for (jb = 0; jb < bsorder; jb++) { + u0 = thetai2[m][jb][0]; + u1 = thetai2[m][jb][1]; + u2 = thetai2[m][jb][2]; + term0 = fmp[m][0]*u0*v0 + fmp[m][2]*u1*v0 + fmp[m][3]*u0*v1 + + fmp[m][5]*u2*v0 + fmp[m][6]*u0*v2 + fmp[m][9]*u1*v1; + term1 = fmp[m][1]*u0*v0 + fmp[m][7]*u1*v0 + fmp[m][8]*u0*v1; + term2 = fmp[m][4]*u0*v0; + + i = igrid[m][0] - nlpts; + for (ib = 0; ib < bsorder; ib++) { + t0 = thetai1[m][ib][0]; + t1 = thetai1[m][ib][1]; + t2 = thetai1[m][ib][2]; + grid[k][j][i] += term0*t0 + term1*t1 + term2*t2; + + // if (m == 0) { + // int istencil = kb*bsorder*bsorder + jb*bsorder + ib + 1; + // printf("GRIDMPOLE iStencil %d atomID %d igrid %d %d %d " + // "ibjbkb %d %d %d ijk %d %d %d " + // "th1 %g %g %g th2 %g %g %g th3 %g %g %g " + // "fmp0-9 %e %e %e %e %e %e %e %e %e %e " + // "term012 %e %e %e " + // "gridvalue %g\n", + // istencil,atom->tag[m], + // igrid[m][0],igrid[m][1],igrid[m][2], + // ib,jb,kb,i,j,k, + // t0,t1,t2,u0,u1,u2,v0,v1,v2, + // fmp[m][0],fmp[m][1],fmp[m][2], + // fmp[m][3],fmp[m][4],fmp[m][5], + // fmp[m][6],fmp[m][7],fmp[m][8],fmp[m][9], + // term0,term1,term2, + // term0*t0 + term1*t1 + term2*t2); + // } + + i++; + } + j++; + } + k++; + } + } +} + +/* ---------------------------------------------------------------------- + fphi_mpole = multipole potential from grid + fphi_mpole extracts the permanent multipole potential from + the particle mesh Ewald grid +------------------------------------------------------------------------- */ + +void PairAmoeba::fphi_mpole(double ***grid, double **fphi) +{ + int i,j,k,m,ib,jb,kb; + double v0,v1,v2,v3; + double u0,u1,u2,u3; + double t0,t1,t2,t3,tq; + double tu00,tu10,tu01,tu20,tu11; + double tu02,tu21,tu12,tu30,tu03; + double tuv000,tuv100,tuv010,tuv001; + double tuv200,tuv020,tuv002,tuv110; + double tuv101,tuv011,tuv300,tuv030; + double tuv003,tuv210,tuv201,tuv120; + double tuv021,tuv102,tuv012,tuv111; + + int nlpts = (bsorder-1) / 2; + int nrpts = bsorder - nlpts - 1; + + // extract the permanent multipole field at each site + + int nlocal = atom->nlocal; + + for (m = 0; m < nlocal; m++) { + tuv000 = 0.0; + tuv001 = 0.0; + tuv010 = 0.0; + tuv100 = 0.0; + tuv200 = 0.0; + tuv020 = 0.0; + tuv002 = 0.0; + tuv110 = 0.0; + tuv101 = 0.0; + tuv011 = 0.0; + tuv300 = 0.0; + tuv030 = 0.0; + tuv003 = 0.0; + tuv210 = 0.0; + tuv201 = 0.0; + tuv120 = 0.0; + tuv021 = 0.0; + tuv102 = 0.0; + tuv012 = 0.0; + tuv111 = 0.0; + + k = igrid[m][2] - nlpts; + for (kb = 0; kb < bsorder; kb++) { + v0 = thetai3[m][kb][0]; + v1 = thetai3[m][kb][1]; + v2 = thetai3[m][kb][2]; + v3 = thetai3[m][kb][3]; + tu00 = 0.0; + tu10 = 0.0; + tu01 = 0.0; + tu20 = 0.0; + tu11 = 0.0; + tu02 = 0.0; + tu30 = 0.0; + tu21 = 0.0; + tu12 = 0.0; + tu03 = 0.0; + + j = igrid[m][1] - nlpts; + for (jb = 0; jb < bsorder; jb++) { + u0 = thetai2[m][jb][0]; + u1 = thetai2[m][jb][1]; + u2 = thetai2[m][jb][2]; + u3 = thetai2[m][jb][3]; + t0 = 0.0; + t1 = 0.0; + t2 = 0.0; + t3 = 0.0; + + i = igrid[m][0] - nlpts; + for (ib = 0; ib < bsorder; ib++) { + tq = grid[k][j][i]; + t0 += tq*thetai1[m][ib][0]; + t1 += tq*thetai1[m][ib][1]; + t2 += tq*thetai1[m][ib][2]; + t3 += tq*thetai1[m][ib][3]; + i++; + } + + tu00 += t0*u0; + tu10 += t1*u0; + tu01 += t0*u1; + tu20 += t2*u0; + tu11 += t1*u1; + tu02 += t0*u2; + tu30 += t3*u0; + tu21 += t2*u1; + tu12 += t1*u2; + tu03 += t0*u3; + j++; + } + + tuv000 += tu00*v0; + tuv100 += tu10*v0; + tuv010 += tu01*v0; + tuv001 += tu00*v1; + tuv200 += tu20*v0; + tuv020 += tu02*v0; + tuv002 += tu00*v2; + tuv110 += tu11*v0; + tuv101 += tu10*v1; + tuv011 += tu01*v1; + tuv300 += tu30*v0; + tuv030 += tu03*v0; + tuv003 += tu00*v3; + tuv210 += tu21*v0; + tuv201 += tu20*v1; + tuv120 += tu12*v0; + tuv021 += tu02*v1; + tuv102 += tu10*v2; + tuv012 += tu01*v2; + tuv111 += tu11*v1; + k++; + } + + fphi[m][0] = tuv000; + fphi[m][1] = tuv100; + fphi[m][2] = tuv010; + fphi[m][3] = tuv001; + fphi[m][4] = tuv200; + fphi[m][5] = tuv020; + fphi[m][6] = tuv002; + fphi[m][7] = tuv110; + fphi[m][8] = tuv101; + fphi[m][9] = tuv011; + fphi[m][10] = tuv300; + fphi[m][11] = tuv030; + fphi[m][12] = tuv003; + fphi[m][13] = tuv210; + fphi[m][14] = tuv201; + fphi[m][15] = tuv120; + fphi[m][16] = tuv021; + fphi[m][17] = tuv102; + fphi[m][18] = tuv012; + fphi[m][19] = tuv111; + } +} + +/* ---------------------------------------------------------------------- + grid_uind = put induced dipoles on PME grid + grid_uind maps fractional induced dipoles to the PME grid +------------------------------------------------------------------------- */ + +void PairAmoeba::grid_uind(double **fuind, double **fuinp, double ****grid) +{ + int i,j,k,m,ib,jb,kb; + double v0,u0,t0; + double v1,u1,t1; + double term01,term11; + double term02,term12; + + int nlpts = (bsorder-1) / 2; + int nrpts = bsorder - nlpts - 1; + + // put the induced dipole moments onto the grid + + int nlocal = atom->nlocal; + + for (m = 0; m < nlocal; m++) { + + k = igrid[m][2] - nlpts; + for (kb = 0; kb < bsorder; kb++) { + v0 = thetai3[m][kb][0]; + v1 = thetai3[m][kb][1]; + + j = igrid[m][1] - nlpts; + for (jb = 0; jb < bsorder; jb++) { + u0 = thetai2[m][jb][0]; + u1 = thetai2[m][jb][1]; + term01 = fuind[m][1]*u1*v0 + fuind[m][2]*u0*v1; + term11 = fuind[m][0]*u0*v0; + term02 = fuinp[m][1]*u1*v0 + fuinp[m][2]*u0*v1; + term12 = fuinp[m][0]*u0*v0; + + i = igrid[m][0] - nlpts; + for (ib = 0; ib < bsorder; ib++) { + t0 = thetai1[m][ib][0]; + t1 = thetai1[m][ib][1]; + grid[k][j][i][0] += term01*t0 + term11*t1; + grid[k][j][i][1] += term02*t0 + term12*t1; + //printf("gridcheck %g %g \n",grid[k][j][i][0],grid[k][j][i][0]); + i++; + } + j++; + } + k++; + } + } +} + +/* ---------------------------------------------------------------------- + fphi_uind = induced potential from grid + fphi_uind extracts the induced dipole potential from the particle mesh Ewald grid +------------------------------------------------------------------------- */ + +void PairAmoeba::fphi_uind(double ****grid, double **fdip_phi1, + double **fdip_phi2, double **fdip_sum_phi) +{ + int i,j,k,m,ib,jb,kb; + double v0,v1,v2,v3; + double u0,u1,u2,u3; + double t0,t1,t2,t3; + double t0_1,t0_2,t1_1,t1_2; + double t2_1,t2_2,tq_1,tq_2; + double tu00,tu10,tu01,tu20,tu11; + double tu02,tu30,tu21,tu12,tu03; + double tu00_1,tu01_1,tu10_1; + double tu00_2,tu01_2,tu10_2; + double tu20_1,tu11_1,tu02_1; + double tu20_2,tu11_2,tu02_2; + double tuv100_1,tuv010_1,tuv001_1; + double tuv100_2,tuv010_2,tuv001_2; + double tuv200_1,tuv020_1,tuv002_1; + double tuv110_1,tuv101_1,tuv011_1; + double tuv200_2,tuv020_2,tuv002_2; + double tuv110_2,tuv101_2,tuv011_2; + double tuv000,tuv100,tuv010,tuv001; + double tuv200,tuv020,tuv002,tuv110; + double tuv101,tuv011,tuv300,tuv030; + double tuv003,tuv210,tuv201,tuv120; + double tuv021,tuv102,tuv012,tuv111; + + int nlpts = (bsorder-1) / 2; + int nrpts = bsorder - nlpts - 1; + + // extract the permanent multipole field at each site + + int nlocal = atom->nlocal; + + for (m = 0; m < nlocal; m++) { + tuv100_1 = 0.0; + tuv010_1 = 0.0; + tuv001_1 = 0.0; + tuv200_1 = 0.0; + tuv020_1 = 0.0; + tuv002_1 = 0.0; + tuv110_1 = 0.0; + tuv101_1 = 0.0; + tuv011_1 = 0.0; + tuv100_2 = 0.0; + tuv010_2 = 0.0; + tuv001_2 = 0.0; + tuv200_2 = 0.0; + tuv020_2 = 0.0; + tuv002_2 = 0.0; + tuv110_2 = 0.0; + tuv101_2 = 0.0; + tuv011_2 = 0.0; + tuv000 = 0.0; + tuv001 = 0.0; + tuv010 = 0.0; + tuv100 = 0.0; + tuv200 = 0.0; + tuv020 = 0.0; + tuv002 = 0.0; + tuv110 = 0.0; + tuv101 = 0.0; + tuv011 = 0.0; + tuv300 = 0.0; + tuv030 = 0.0; + tuv003 = 0.0; + tuv210 = 0.0; + tuv201 = 0.0; + tuv120 = 0.0; + tuv021 = 0.0; + tuv102 = 0.0; + tuv012 = 0.0; + tuv111 = 0.0; + + k = igrid[m][2] - nlpts; + for (kb = 0; kb < bsorder; kb++) { + v0 = thetai3[m][kb][0]; + v1 = thetai3[m][kb][1]; + v2 = thetai3[m][kb][2]; + v3 = thetai3[m][kb][3]; + tu00_1 = 0.0; + tu01_1 = 0.0; + tu10_1 = 0.0; + tu20_1 = 0.0; + tu11_1 = 0.0; + tu02_1 = 0.0; + tu00_2 = 0.0; + tu01_2 = 0.0; + tu10_2 = 0.0; + tu20_2 = 0.0; + tu11_2 = 0.0; + tu02_2 = 0.0; + tu00 = 0.0; + tu10 = 0.0; + tu01 = 0.0; + tu20 = 0.0; + tu11 = 0.0; + tu02 = 0.0; + tu30 = 0.0; + tu21 = 0.0; + tu12 = 0.0; + tu03 = 0.0; + + j = igrid[m][1] - nlpts; + for (jb = 0; jb < bsorder; jb++) { + u0 = thetai2[m][jb][0]; + u1 = thetai2[m][jb][1]; + u2 = thetai2[m][jb][2]; + u3 = thetai2[m][jb][3]; + t0_1 = 0.0; + t1_1 = 0.0; + t2_1 = 0.0; + t0_2 = 0.0; + t1_2 = 0.0; + t2_2 = 0.0; + t3 = 0.0; + + i = igrid[m][0] - nlpts; + for (ib = 0; ib < bsorder; ib++) { + tq_1 = grid[k][j][i][0]; + tq_2 = grid[k][j][i][1]; + t0_1 += tq_1*thetai1[m][ib][0]; + t1_1 += tq_1*thetai1[m][ib][1]; + t2_1 += tq_1*thetai1[m][ib][2]; + t0_2 += tq_2*thetai1[m][ib][0]; + t1_2 += tq_2*thetai1[m][ib][1]; + t2_2 += tq_2*thetai1[m][ib][2]; + t3 += (tq_1+tq_2)*thetai1[m][ib][3]; + i++; + } + + tu00_1 += t0_1*u0; + tu10_1 += t1_1*u0; + tu01_1 += t0_1*u1; + tu20_1 += t2_1*u0; + tu11_1 += t1_1*u1; + tu02_1 += t0_1*u2; + tu00_2 += t0_2*u0; + tu10_2 += t1_2*u0; + tu01_2 += t0_2*u1; + tu20_2 += t2_2*u0; + tu11_2 += t1_2*u1; + tu02_2 += t0_2*u2; + t0 = t0_1 + t0_2; + t1 = t1_1 + t1_2; + t2 = t2_1 + t2_2; + tu00 += t0*u0; + tu10 += t1*u0; + tu01 += t0*u1; + tu20 += t2*u0; + tu11 += t1*u1; + tu02 += t0*u2; + tu30 += t3*u0; + tu21 += t2*u1; + tu12 += t1*u2; + tu03 += t0*u3; + j++; + } + + tuv100_1 += tu10_1*v0; + tuv010_1 += tu01_1*v0; + tuv001_1 += tu00_1*v1; + tuv200_1 += tu20_1*v0; + tuv020_1 += tu02_1*v0; + tuv002_1 += tu00_1*v2; + tuv110_1 += tu11_1*v0; + tuv101_1 += tu10_1*v1; + tuv011_1 += tu01_1*v1; + tuv100_2 += tu10_2*v0; + tuv010_2 += tu01_2*v0; + tuv001_2 += tu00_2*v1; + tuv200_2 += tu20_2*v0; + tuv020_2 += tu02_2*v0; + tuv002_2 += tu00_2*v2; + tuv110_2 += tu11_2*v0; + tuv101_2 += tu10_2*v1; + tuv011_2 += tu01_2*v1; + tuv000 += tu00*v0; + tuv100 += tu10*v0; + tuv010 += tu01*v0; + tuv001 += tu00*v1; + tuv200 += tu20*v0; + tuv020 += tu02*v0; + tuv002 += tu00*v2; + tuv110 += tu11*v0; + tuv101 += tu10*v1; + tuv011 += tu01*v1; + tuv300 += tu30*v0; + tuv030 += tu03*v0; + tuv003 += tu00*v3; + tuv210 += tu21*v0; + tuv201 += tu20*v1; + tuv120 += tu12*v0; + tuv021 += tu02*v1; + tuv102 += tu10*v2; + tuv012 += tu01*v2; + tuv111 += tu11*v1; + k++; + } + + fdip_phi1[m][0] = 0.0; + fdip_phi1[m][1] = tuv100_1; + fdip_phi1[m][2] = tuv010_1; + fdip_phi1[m][3] = tuv001_1; + fdip_phi1[m][4] = tuv200_1; + fdip_phi1[m][5] = tuv020_1; + fdip_phi1[m][6] = tuv002_1; + fdip_phi1[m][7] = tuv110_1; + fdip_phi1[m][8] = tuv101_1; + fdip_phi1[m][9] = tuv011_1; + + fdip_phi2[m][0] = 0.0; + fdip_phi2[m][1] = tuv100_2; + fdip_phi2[m][2] = tuv010_2; + fdip_phi2[m][3] = tuv001_2; + fdip_phi2[m][4] = tuv200_2; + fdip_phi2[m][5] = tuv020_2; + fdip_phi2[m][6] = tuv002_2; + fdip_phi2[m][7] = tuv110_2; + fdip_phi2[m][8] = tuv101_2; + fdip_phi2[m][9] = tuv011_2; + + fdip_sum_phi[m][0] = tuv000; + fdip_sum_phi[m][1] = tuv100; + fdip_sum_phi[m][2] = tuv010; + fdip_sum_phi[m][3] = tuv001; + fdip_sum_phi[m][4] = tuv200; + fdip_sum_phi[m][5] = tuv020; + fdip_sum_phi[m][6] = tuv002; + fdip_sum_phi[m][7] = tuv110; + fdip_sum_phi[m][8] = tuv101; + fdip_sum_phi[m][9] = tuv011; + fdip_sum_phi[m][10] = tuv300; + fdip_sum_phi[m][11] = tuv030; + fdip_sum_phi[m][12] = tuv003; + fdip_sum_phi[m][13] = tuv210; + fdip_sum_phi[m][14] = tuv201; + fdip_sum_phi[m][15] = tuv120; + fdip_sum_phi[m][16] = tuv021; + fdip_sum_phi[m][17] = tuv102; + fdip_sum_phi[m][18] = tuv012; + fdip_sum_phi[m][19] = tuv111; + } +} + +/* ---------------------------------------------------------------------- + grid_disp = put dispersion sites on PME grid + grid_disp maps dispersion coefficients to PME grid +------------------------------------------------------------------------- */ + +void PairAmoeba::grid_disp(double ***grid) +{ + int i,j,k,m,ib,jb,kb,itype,iclass; + double v0,u0,t0; + double term; + + int nlpts = (bsorder-1) / 2; + int nrpts = bsorder - nlpts - 1; + + // put the dispersion sites onto the grid + + int nlocal = atom->nlocal; + + for (m = 0; m < nlocal; m++) { + itype = amtype[m]; + iclass = amtype2class[itype]; + + k = igrid[m][2] - nlpts; + for (kb = 0; kb < bsorder; kb++) { + v0 = thetai3[m][kb][0] * csix[iclass]; + + j = igrid[m][1] - nlpts; + for (jb = 0; jb < bsorder; jb++) { + u0 = thetai2[m][jb][0]; + term = v0 * u0; + + i = igrid[m][0] - nlpts; + for (ib = 0; ib < bsorder; ib++) { + t0 = thetai1[m][ib][0]; + grid[k][j][i] += term*t0; + i++; + } + j++; + } + k++; + } + } +} + +/* ---------------------------------------------------------------------- + kewald = setup for particle mesh Ewald sum + kewald assigns particle mesh Ewald parameters and options for a periodic system +------------------------------------------------------------------------- */ + +void PairAmoeba::kewald() +{ + int i,k,next; + int nbig,minfft; + int nfft1,nfft2,nfft3; + double delta,rmax; + double edens,ddens; + double size,slope; + + // use_ewald is for multipole and induce and polar + + if (!use_ewald) aeewald = apewald = 0.0; + + if (use_ewald) { + if (!aeewald_key) aeewald = ewaldcof(ewaldcut); + + if (!apewald_key) { + apewald = aeewald; + size = MIN(domain->xprd,domain->yprd); + size = MIN(size,domain->zprd); + if (size < 6.0) { + slope = (1.0-apewald) / 2.0; + apewald += slope*(6.0-size); + } + } + + if (!pmegrid_key) { + delta = 1.0e-8; + edens = 1.2; + nefft1 = static_cast (domain->xprd*edens-delta) + 1; + nefft2 = static_cast (domain->yprd*edens-delta) + 1; + nefft3 = static_cast (domain->zprd*edens-delta) + 1; + } + + // round grid sizes up to be factorable by 2,3,5 + // NOTE: also worry about satisfying Tinker minfft ? + + while (!factorable(nefft1)) nefft1++; + while (!factorable(nefft2)) nefft2++; + while (!factorable(nefft3)) nefft3++; + } + + // use_dewald is for dispersion + + if (!use_dewald) adewald = 0.0; + + if (use_dewald) { + if (!adewald_key) adewald = ewaldcof(dispcut); + + if (!dpmegrid_key) { + delta = 1.0e-8; + ddens = 0.8; + ndfft1 = static_cast (domain->xprd*ddens-delta) + 1; + ndfft2 = static_cast (domain->yprd*ddens-delta) + 1; + ndfft3 = static_cast (domain->zprd*ddens-delta) + 1; + } + + // increase grid sizes until factorable by 2,3,5 + // NOTE: also worry about satisfying Tinker minfft ? + + while (!factorable(ndfft1)) ndfft1++; + while (!factorable(ndfft2)) ndfft3++; + while (!factorable(ndfft3)) ndfft3++; + } + + // done if no Ewald + + if (!use_ewald && !use_dewald) return; + + // set maximum sizes for PME grids and B-spline order + // allocate vectors and arrays accordingly + + nfft1 = nfft2 = nfft3 = 0; + if (use_ewald) nfft1 = nefft1; + if (use_ewald) nfft2 = nefft2; + if (use_ewald) nfft3 = nefft3; + if (use_dewald) nfft1 = MAX(nfft1,ndfft1); + if (use_dewald) nfft2 = MAX(nfft2,ndfft2); + if (use_dewald) nfft3 = MAX(nfft3,ndfft3); + + bsordermax = 0; + if (use_ewald) bsordermax = bseorder; + if (use_ewald) bsordermax = MAX(bsordermax,bsporder); + if (use_dewald) bsordermax = MAX(bsordermax,bsdorder); + + memory->create(bsmod1,nfft1,"amoeba:bsmod1"); + memory->create(bsmod2,nfft2,"amoeba:bsmod2"); + memory->create(bsmod3,nfft3,"amoeba:bsmod3"); + memory->create(bsbuild,bsordermax,bsordermax,"amoeba:bsbuild"); +} + +/* ---------------------------------------------------------------------- + ewaldcof = estimation of Ewald coefficient + ewaldcof finds an Ewald coefficient such that all terms + beyond the specified cutoff distance will have a value less + than a specified tolerance +------------------------------------------------------------------------- */ + +double PairAmoeba::ewaldcof(double cutoff) +{ + int i,k,m; + double x,xlo,xhi,y; + double eps,ratio; + + // set the tolerance value; use of 1.0d-8 instead of 1.0d-6 + // gives large coefficients that ensure gradient continuity + + eps = 1.0e-8; + + // get approximate value from cutoff and tolerance + + ratio = eps + 1.0; + x = 0.5; + i = 0; + while (ratio >= eps) { + i++; + x *= 2.0; + y = x * cutoff; + ratio = erfc(y) / cutoff; + } + + // use a binary search to refine the coefficient + + k = i + 60; + xlo = 0.0; + xhi = x; + for (m = 0; m < k; m++) { + x = (xlo+xhi) / 2.0; + y = x * cutoff; + ratio = erfc(y) / cutoff; + if (ratio >= eps) xlo = x; + else xhi = x; + } + + return x; +} + +/* ---------------------------------------------------------------------- + check if all factors of n are in factors[] list of length nfactors + return 1 if yes, 0 if no +------------------------------------------------------------------------- */ + +int PairAmoeba::factorable(int n) +{ + int i; + + while (n > 1) { + for (i = 0; i < nfactors; i++) { + if (n % factors[i] == 0) { + n /= factors[i]; + break; + } + } + if (i == nfactors) return 0; + } + + return 1; +} diff --git a/src/AMOEBA/amoeba_multipole.cpp b/src/AMOEBA/amoeba_multipole.cpp new file mode 100644 index 0000000000..c06f07d70c --- /dev/null +++ b/src/AMOEBA/amoeba_multipole.cpp @@ -0,0 +1,1038 @@ +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#include "pair_amoeba.h" +#include +#include +#include "amoeba_convolution.h" +#include "atom.h" +#include "domain.h" +#include "comm.h" +#include "neigh_list.h" +#include "fft3d_wrap.h" +#include "math_const.h" +#include "memory.h" + +using namespace LAMMPS_NS; +using namespace MathConst; + +enum{FIELD,ZRSD,TORQUE,UFLD}; // reverse comm +enum{VDWL,REPULSE,QFER,DISP,MPOLE,POLAR,USOLV,DISP_LONG,MPOLE_LONG,POLAR_LONG}; + +#ifdef FFT_SINGLE +#define ZEROF 0.0f +#define ONEF 1.0f +#else +#define ZEROF 0.0 +#define ONEF 1.0 +#endif + +/* ---------------------------------------------------------------------- + multipole = multipole interactions + adapted from Tinker empole1d() routine +------------------------------------------------------------------------- */ + +void PairAmoeba::multipole() +{ + int i,j,ii,itype; + double e,em; + double felec; + double term,fterm,vterm; + double ci; + double dix,diy,diz; + double qixx,qixy,qixz,qiyy,qiyz,qizz; + double xq,yq,zq; + double xv,yv,zv; + double xd,yd,zd; + double cii,dii,qii; + double xdfield,ydfield,zdfield; + double tem[3]; + double frcx[3],frcy[3],frcz[3]; + + // set cutoffs, taper coeffs, and PME params + + if (use_ewald) choose(MPOLE_LONG); + else choose(MPOLE); + + // owned atoms + + double **x = atom->x; + int nlocal = atom->nlocal; + + // zero repulsion torque on owned + ghost atoms + + int nall = nlocal + atom->nghost; + + for (i = 0; i < nall; i++) { + tq[i][0] = 0.0; + tq[i][1] = 0.0; + tq[i][2] = 0.0; + } + + // set the energy unit conversion factor + + felec = electric / am_dielectric; + + // compute the real space part of the Ewald summation + + if (rspace_flag) multipole_real(); + + // compute the reciprocal space part of the Ewald summation + + //printf("zero check %e \n",empole); + if (kspace_flag) multipole_kspace(); + //printf("kspace energy %e \n",empole); + + // compute the Ewald self-energy term over all the atoms + + term = 2.0 * aewald * aewald; + fterm = -felec * aewald / MY_PIS; + + for (i = 0; i < nlocal; i++) { + ci = rpole[i][0]; + dix = rpole[i][1]; + diy = rpole[i][2]; + diz = rpole[i][3]; + qixx = rpole[i][4]; + qixy = rpole[i][5]; + qixz = rpole[i][6]; + qiyy = rpole[i][8]; + qiyz = rpole[i][9]; + qizz = rpole[i][12]; + cii = ci*ci; + dii = dix*dix + diy*diy + diz*diz; + qii = 2.0*(qixy*qixy+qixz*qixz+qiyz*qiyz) + + qixx*qixx + qiyy*qiyy + qizz*qizz; + e = fterm * (cii + term*(dii/3.0+2.0*term*qii/5.0)); + empole += e; + } +} + +/* ---------------------------------------------------------------------- + multipole_real = real-space portion of mulipole interactions + adapted from Tinker emreal1d() routine +------------------------------------------------------------------------- */ + +void PairAmoeba::multipole_real() +{ + int i,j,k,itype,jtype,iclass,jclass; + int ii,jj; + int ix,iy,iz; + double e,de,felec; + double bfac; + double alsq2,alsq2n; + double exp2a,ralpha; + double scalek; + double xi,yi,zi; + double xr,yr,zr; + double xix,yix,zix; + double xiy,yiy,ziy; + double xiz,yiz,ziz; + double r,r2,rr1,rr3; + double rr5,rr7,rr9,rr11; + double rr1i,rr3i,rr5i,rr7i; + double rr1k,rr3k,rr5k,rr7k; + double rr1ik,rr3ik,rr5ik; + double rr7ik,rr9ik,rr11ik; + double ci,dix,diy,diz; + double qixx,qixy,qixz; + double qiyy,qiyz,qizz; + double ck,dkx,dky,dkz; + double qkxx,qkxy,qkxz; + double qkyy,qkyz,qkzz; + double dir,dkr,dik,qik; + double qix,qiy,qiz,qir; + double qkx,qky,qkz,qkr; + double diqk,dkqi,qiqk; + double dirx,diry,dirz; + double dkrx,dkry,dkrz; + double dikx,diky,dikz; + double qirx,qiry,qirz; + double qkrx,qkry,qkrz; + double qikx,qiky,qikz; + double qixk,qiyk,qizk; + double qkxi,qkyi,qkzi; + double qikrx,qikry,qikrz; + double qkirx,qkiry,qkirz; + double diqkx,diqky,diqkz; + double dkqix,dkqiy,dkqiz; + double diqkrx,diqkry,diqkrz; + double dkqirx,dkqiry,dkqirz; + double dqikx,dqiky,dqikz; + double corei,corek; + double vali,valk; + double alphai,alphak; + double term1,term2,term3; + double term4,term5,term6; + double term1i,term2i,term3i; + double term1k,term2k,term3k; + double term1ik,term2ik,term3ik; + double term4ik,term5ik; + double frcx,frcy,frcz; + double vxx,vyy,vzz; + double vxy,vxz,vyz; + double factor_mpole; + double ttmi[3],ttmk[3]; + double fix[3],fiy[3],fiz[3]; + double dmpi[9],dmpj[9]; + double dmpij[11]; + double bn[6]; + + int inum,jnum; + int *ilist,*jlist,*numneigh,**firstneigh; + + // owned atoms + + pval = atom->dvector[index_pval]; + + double **x = atom->x; + double **f = atom->f; + int nlocal = atom->nlocal; + + // neigh list + + inum = list->inum; + ilist = list->ilist; + numneigh = list->numneigh; + firstneigh = list->firstneigh; + + // set conversion factor, cutoff and switching coefficients + + felec = electric / am_dielectric; + + // DEBUG + + //int count = 0; + //int imin,imax; + + // compute the real space portion of the Ewald summation + + for (ii = 0; ii < inum; ii++) { + i = ilist[ii]; + itype = amtype[i]; + iclass = amtype2class[itype]; + jlist = firstneigh[i]; + jnum = numneigh[i]; + + xi = x[i][0]; + yi = x[i][1]; + zi = x[i][2]; + ci = rpole[i][0]; + dix = rpole[i][1]; + diy = rpole[i][2]; + diz = rpole[i][3]; + qixx = rpole[i][4]; + qixy = rpole[i][5]; + qixz = rpole[i][6]; + qiyy = rpole[i][8]; + qiyz = rpole[i][9]; + qizz = rpole[i][12]; + if (hippo) { + corei = pcore[iclass]; + alphai = palpha[iclass]; + vali = pval[i]; + } + + // evaluate all sites within the cutoff distance + + for (jj = 0; jj < jnum; jj++) { + j = jlist[jj]; + factor_mpole = special_mpole[sbmask15(j)]; + j &= NEIGHMASK15; + + xr = x[j][0] - xi; + yr = x[j][1] - yi; + zr = x[j][2] - zi; + r2 = xr*xr + yr*yr + zr*zr; + if (r2 > off2) continue; + + // DEBUG + + //imin = MIN(atom->tag[i],atom->tag[j]); + //imax = MAX(atom->tag[i],atom->tag[j]); + + jtype = amtype[j]; + jclass = amtype2class[jtype]; + + r = sqrt(r2); + ck = rpole[j][0]; + dkx = rpole[j][1]; + dky = rpole[j][2]; + dkz = rpole[j][3]; + qkxx = rpole[j][4]; + qkxy = rpole[j][5]; + qkxz = rpole[j][6]; + qkyy = rpole[j][8]; + qkyz = rpole[j][9]; + qkzz = rpole[j][12]; + + // intermediates involving moments and separation distance + + dir = dix*xr + diy*yr + diz*zr; + qix = qixx*xr + qixy*yr + qixz*zr; + qiy = qixy*xr + qiyy*yr + qiyz*zr; + qiz = qixz*xr + qiyz*yr + qizz*zr; + qir = qix*xr + qiy*yr + qiz*zr; + dkr = dkx*xr + dky*yr + dkz*zr; + qkx = qkxx*xr + qkxy*yr + qkxz*zr; + qky = qkxy*xr + qkyy*yr + qkyz*zr; + qkz = qkxz*xr + qkyz*yr + qkzz*zr; + qkr = qkx*xr + qky*yr + qkz*zr; + dik = dix*dkx + diy*dky + diz*dkz; + qik = qix*qkx + qiy*qky + qiz*qkz; + diqk = dix*qkx + diy*qky + diz*qkz; + dkqi = dkx*qix + dky*qiy + dkz*qiz; + qiqk = 2.0*(qixy*qkxy+qixz*qkxz+qiyz*qkyz) + + qixx*qkxx + qiyy*qkyy + qizz*qkzz; + + // additional intermediates involving moments and distance + + dirx = diy*zr - diz*yr; + diry = diz*xr - dix*zr; + dirz = dix*yr - diy*xr; + dkrx = dky*zr - dkz*yr; + dkry = dkz*xr - dkx*zr; + dkrz = dkx*yr - dky*xr; + dikx = diy*dkz - diz*dky; + diky = diz*dkx - dix*dkz; + dikz = dix*dky - diy*dkx; + qirx = qiz*yr - qiy*zr; + qiry = qix*zr - qiz*xr; + qirz = qiy*xr - qix*yr; + qkrx = qkz*yr - qky*zr; + qkry = qkx*zr - qkz*xr; + qkrz = qky*xr - qkx*yr; + qikx = qky*qiz - qkz*qiy; + qiky = qkz*qix - qkx*qiz; + qikz = qkx*qiy - qky*qix; + qixk = qixx*qkx + qixy*qky + qixz*qkz; + qiyk = qixy*qkx + qiyy*qky + qiyz*qkz; + qizk = qixz*qkx + qiyz*qky + qizz*qkz; + qkxi = qkxx*qix + qkxy*qiy + qkxz*qiz; + qkyi = qkxy*qix + qkyy*qiy + qkyz*qiz; + qkzi = qkxz*qix + qkyz*qiy + qkzz*qiz; + qikrx = qizk*yr - qiyk*zr; + qikry = qixk*zr - qizk*xr; + qikrz = qiyk*xr - qixk*yr; + qkirx = qkzi*yr - qkyi*zr; + qkiry = qkxi*zr - qkzi*xr; + qkirz = qkyi*xr - qkxi*yr; + diqkx = dix*qkxx + diy*qkxy + diz*qkxz; + diqky = dix*qkxy + diy*qkyy + diz*qkyz; + diqkz = dix*qkxz + diy*qkyz + diz*qkzz; + dkqix = dkx*qixx + dky*qixy + dkz*qixz; + dkqiy = dkx*qixy + dky*qiyy + dkz*qiyz; + dkqiz = dkx*qixz + dky*qiyz + dkz*qizz; + diqkrx = diqkz*yr - diqky*zr; + diqkry = diqkx*zr - diqkz*xr; + diqkrz = diqky*xr - diqkx*yr; + dkqirx = dkqiz*yr - dkqiy*zr; + dkqiry = dkqix*zr - dkqiz*xr; + dkqirz = dkqiy*xr - dkqix*yr; + dqikx = diy*qkz - diz*qky + dky*qiz - dkz*qiy - + 2.0*(qixy*qkxz+qiyy*qkyz+qiyz*qkzz - qixz*qkxy-qiyz*qkyy-qizz*qkyz); + dqiky = diz*qkx - dix*qkz + dkz*qix - dkx*qiz - + 2.0*(qixz*qkxx+qiyz*qkxy+qizz*qkxz - qixx*qkxz-qixy*qkyz-qixz*qkzz); + dqikz = dix*qky - diy*qkx + dkx*qiy - dky*qix - + 2.0*(qixx*qkxy+qixy*qkyy+qixz*qkyz - qixy*qkxx-qiyy*qkxy-qiyz*qkxz); + + // get reciprocal distance terms for this interaction + + rr1 = felec / r; + rr3 = rr1 / r2; + rr5 = 3.0 * rr3 / r2; + rr7 = 5.0 * rr5 / r2; + rr9 = 7.0 * rr7 / r2; + rr11 = 9.0 * rr9 / r2; + + // calculate the real space Ewald error function terms + + ralpha = aewald * r; + bn[0] = erfc(ralpha) / r; + alsq2 = 2.0 * aewald*aewald; + alsq2n = 0.0; + if (aewald > 0.0) alsq2n = 1.0 / (MY_PIS*aewald); + exp2a = exp(-ralpha*ralpha); + for (k = 1; k < 6; k++) { + bfac = (double) (k+k-1); + alsq2n = alsq2 * alsq2n; + bn[k] = (bfac*bn[k-1]+alsq2n*exp2a) / r2; + } + for (k = 0; k < 6; k++) bn[k] *= felec; + + // find damped multipole intermediates and energy value + + if (hippo) { + corek = pcore[jclass]; + alphak = palpha[jclass]; + valk = pval[j]; + + /* + printf("HIPPO MPOLE ij %d %d: pcore/alpha/val I %g %g %g: J %g %g %g\n", + atom->tag[i],atom->tag[j],corei,alphai,vali,corek,alphak,valk); + */ + + term1 = corei*corek; + term1i = corek*vali; + term2i = corek*dir; + term3i = corek*qir; + term1k = corei*valk; + term2k = -corei*dkr; + term3k = corei*qkr; + term1ik = vali*valk; + term2ik = valk*dir - vali*dkr + dik; + term3ik = vali*qkr + valk*qir - dir*dkr + 2.0*(dkqi-diqk+qiqk); + term4ik = dir*qkr - dkr*qir - 4.0*qik; + term5ik = qir*qkr; + damppole(r,11,alphai,alphak,dmpi,dmpj,dmpij); + scalek = factor_mpole; + rr1i = bn[0] - (1.0-scalek*dmpi[0])*rr1; + rr3i = bn[1] - (1.0-scalek*dmpi[2])*rr3; + rr5i = bn[2] - (1.0-scalek*dmpi[4])*rr5; + rr7i = bn[3] - (1.0-scalek*dmpi[6])*rr7; + rr1k = bn[0] - (1.0-scalek*dmpj[0])*rr1; + rr3k = bn[1] - (1.0-scalek*dmpj[2])*rr3; + rr5k = bn[2] - (1.0-scalek*dmpj[4])*rr5; + rr7k = bn[3] - (1.0-scalek*dmpj[6])*rr7; + rr1ik = bn[0] - (1.0-scalek*dmpij[0])*rr1; + rr3ik = bn[1] - (1.0-scalek*dmpij[2])*rr3; + rr5ik = bn[2] - (1.0-scalek*dmpij[4])*rr5; + rr7ik = bn[3] - (1.0-scalek*dmpij[6])*rr7; + rr9ik = bn[4] - (1.0-scalek*dmpij[8])*rr9; + rr11ik = bn[5] - (1.0-scalek*dmpij[10])*rr11; + rr1 = bn[0] - (1.0-scalek)*rr1; + rr3 = bn[1] - (1.0-scalek)*rr3; + e = term1*rr1 + term4ik*rr7ik + term5ik*rr9ik + + term1i*rr1i + term1k*rr1k + term1ik*rr1ik + + term2i*rr3i + term2k*rr3k + term2ik*rr3ik + + term3i*rr5i + term3k*rr5k + term3ik*rr5ik; + + // find damped multipole intermediates for force and torque + + de = term1*rr3 + term4ik*rr9ik + term5ik*rr11ik + + term1i*rr3i + term1k*rr3k + term1ik*rr3ik + + term2i*rr5i + term2k*rr5k + term2ik*rr5ik + + term3i*rr7i + term3k*rr7k + term3ik*rr7ik; + term1 = -corek*rr3i - valk*rr3ik + dkr*rr5ik - qkr*rr7ik; + term2 = corei*rr3k + vali*rr3ik + dir*rr5ik + qir*rr7ik; + term3 = 2.0 * rr5ik; + term4 = -2.0 * (corek*rr5i+valk*rr5ik - dkr*rr7ik+qkr*rr9ik); + term5 = -2.0 * (corei*rr5k+vali*rr5ik + dir*rr7ik+qir*rr9ik); + term6 = 4.0 * rr7ik; + rr3 = rr3ik; + + // find standard multipole intermediates and energy value + + } else { + term1 = ci*ck; + term2 = ck*dir - ci*dkr + dik; + term3 = ci*qkr + ck*qir - dir*dkr + 2.0*(dkqi-diqk+qiqk); + term4 = dir*qkr - dkr*qir - 4.0*qik; + term5 = qir*qkr; + scalek = 1.0 - factor_mpole; + rr1 = bn[0] - scalek*rr1; + rr3 = bn[1] - scalek*rr3; + rr5 = bn[2] - scalek*rr5; + rr7 = bn[3] - scalek*rr7; + rr9 = bn[4] - scalek*rr9; + rr11 = bn[5] - scalek*rr11; + e = term1*rr1 + term2*rr3 + term3*rr5 + term4*rr7 + term5*rr9; + + // find standard multipole intermediates for force and torque + + de = term1*rr3 + term2*rr5 + term3*rr7 + term4*rr9 + term5*rr11; + term1 = -ck*rr3 + dkr*rr5 - qkr*rr7; + term2 = ci*rr3 + dir*rr5 + qir*rr7; + term3 = 2.0 * rr5; + term4 = 2.0 * (-ck*rr5+dkr*rr7-qkr*rr9); + term5 = 2.0 * (-ci*rr5-dir*rr7-qir*rr9); + term6 = 4.0 * rr7; + } + + empole += e; + + // DEBUG + + /* + count++; + + if (imin == 68 && imax == 1021) { + //printf("AAA %d %d %16.12g\n",imin,imax,e); + printf("AAA %d: %d %d: %d %d: %d: %16.12g\n", + me,atom->tag[i],atom->tag[j],i,j,atom->nlocal,e); + printf("XYZ %g %g %g: %g %g %g\n", + x[i][0],x[i][1],x[i][2],x[j][0],x[j][1],x[j][2]); + } + */ + + /* + if (atom->tag[i] == 1 || atom->tag[j] == 1) { + printf("MPOLE %d %d %d: %15.12g %15.12g %g\n", + atom->tag[i],atom->tag[j],j,r,e,factor_mpole); + printf(" BN: %g %g %g: %g %g %g\n",bn[0],bn[1],bn[2],bn[3],bn[4],bn[5]); + } + */ + + // compute the force components for this interaction + + frcx = de*xr + term1*dix + term2*dkx + term3*(diqkx-dkqix) + + term4*qix + term5*qkx + term6*(qixk+qkxi); + frcy = de*yr + term1*diy + term2*dky + term3*(diqky-dkqiy) + + term4*qiy + term5*qky + term6*(qiyk+qkyi); + frcz = de*zr + term1*diz + term2*dkz + term3*(diqkz-dkqiz) + + term4*qiz + term5*qkz + term6*(qizk+qkzi); + + // compute the torque components for this interaction + + ttmi[0] = -rr3*dikx + term1*dirx + term3*(dqikx+dkqirx) - + term4*qirx - term6*(qikrx+qikx); + ttmi[1] = -rr3*diky + term1*diry + term3*(dqiky+dkqiry) - + term4*qiry - term6*(qikry+qiky); + ttmi[2] = -rr3*dikz + term1*dirz + term3*(dqikz+dkqirz) - + term4*qirz - term6*(qikrz+qikz); + ttmk[0] = rr3*dikx + term2*dkrx - term3*(dqikx+diqkrx) - + term5*qkrx - term6*(qkirx-qikx); + ttmk[1] = rr3*diky + term2*dkry - term3*(dqiky+diqkry) - + term5*qkry - term6*(qkiry-qiky); + ttmk[2] = rr3*dikz + term2*dkrz - term3*(dqikz+diqkrz) - + term5*qkrz - term6*(qkirz-qikz); + + // increment force-based gradient and torque on first site + + fmpole[i][0] += frcx; + fmpole[i][1] += frcy; + fmpole[i][2] += frcz; + tq[i][0] += ttmi[0]; + tq[i][1] += ttmi[1]; + tq[i][2] += ttmi[2]; + + // increment force-based gradient and torque on second site + + fmpole[j][0] -= frcx; + fmpole[j][1] -= frcy; + fmpole[j][2] -= frcz; + tq[j][0] += ttmk[0]; + tq[j][1] += ttmk[1]; + tq[j][2] += ttmk[2]; + + // increment the virial due to pairwise Cartesian forces + + vxx = -xr * frcx; + vxy = -0.5 * (yr*frcx+xr*frcy); + vxz = -0.5 * (zr*frcx+xr*frcz); + vyy = -yr * frcy; + vyz = -0.5 * (zr*frcy+yr*frcz); + vzz = -zr * frcz; + + virmpole[0] += vxx; + virmpole[1] += vyy; + virmpole[2] += vzz; + virmpole[3] += vxy; + virmpole[4] += vxz; + virmpole[5] += vyz; + + // energy = e + // virial = 6-vec vir + // NOTE: add tally function + + if (evflag) { + } + } + } + + // reverse comm to sum torque from ghost atoms to owned atoms + + crstyle = TORQUE; + comm->reverse_comm_pair(this); + + // resolve site torques then increment forces and virial + + for (i = 0; i < nlocal; i++) { + torque2force(i,tq[i],fix,fiy,fiz,fmpole); + + iz = zaxis2local[i]; + ix = xaxis2local[i]; + iy = yaxis2local[i]; + + xiz = x[iz][0] - x[i][0]; + yiz = x[iz][1] - x[i][1]; + ziz = x[iz][2] - x[i][2]; + xix = x[ix][0] - x[i][0]; + yix = x[ix][1] - x[i][1]; + zix = x[ix][2] - x[i][2]; + xiy = x[iy][0] - x[i][0]; + yiy = x[iy][1] - x[i][1]; + ziy = x[iy][2] - x[i][2]; + + vxx = xix*fix[0] + xiy*fiy[0] + xiz*fiz[0]; + vxy = 0.5 * (yix*fix[0] + yiy*fiy[0] + yiz*fiz[0] + + xix*fix[1] + xiy*fiy[1] + xiz*fiz[1]); + vxz = 0.5 * (zix*fix[0] + ziy*fiy[0] + ziz*fiz[0] + + xix*fix[2] + xiy*fiy[2] + xiz*fiz[2]); + vyy = yix*fix[1] + yiy*fiy[1] + yiz*fiz[1]; + vyz = 0.5 * (zix*fix[1] + ziy*fiy[1] + ziz*fiz[1] + + yix*fix[2] + yiy*fiy[2] + yiz*fiz[2]); + vzz = zix*fix[2] + ziy*fiy[2] + ziz*fiz[2]; + + virmpole[0] += vxx; + virmpole[1] += vyy; + virmpole[2] += vzz; + virmpole[3] += vxy; + virmpole[4] += vxz; + virmpole[5] += vyz; + } +} + +/* ---------------------------------------------------------------------- + multipole_kspace = KSpace portion of multipole interactions + adapted from Tinker emrecip1() routine + literature reference: + C. Sagui, L. G. Pedersen and T. A. Darden, "Towards an Accurate + Representation of Electrostatics in Classical Force Fields: + Efficient Implementation of Multipolar Interactions in + Biomolecular Simulations", Journal of Chemical Physics, 120, + 73-87 (2004) +------------------------------------------------------------------------- */ + +void PairAmoeba::multipole_kspace() +{ + int i,j,k,n,ix,iy,iz; + int nhalf1,nhalf2,nhalf3; + int nxlo,nxhi,nylo,nyhi,nzlo,nzhi; + double e,eterm,felec; + double r1,r2,r3; + double h1,h2,h3; + double f1,f2,f3; + double xix,yix,zix; + double xiy,yiy,ziy; + double xiz,yiz,ziz; + double vxx,vyy,vzz,vxy,vxz,vyz; + double volterm,denom; + double hsq,expterm; + double term,pterm; + double vterm,struc2; + double tem[3],fix[3],fiy[3],fiz[3]; + + // indices into the electrostatic field array + // decremented by 1 versus Fortran + + int deriv1[10] = {1, 4, 7, 8, 10, 15, 17, 13, 14, 19}; + int deriv2[10] = {2, 7, 5, 9, 13, 11, 18, 15, 19, 16}; + int deriv3[10] = {3, 8, 9, 6, 14, 16, 12, 19, 17, 18}; + + // return if the Ewald coefficient is zero + + if (aewald < 1.0e-6) return; + + // owned atoms + + double **x = atom->x; + int nlocal = atom->nlocal; + + double volbox = domain->prd[0] * domain->prd[1] * domain->prd[2]; + + felec = electric / am_dielectric; + + // perform dynamic allocation of arrays + // NOTE: just do this one time? + + memory->create(cmp,nlocal,10,"ameoba/mpole:cmp"); + memory->create(fmp,nlocal,10,"ameoba/mpole:fmp"); + memory->create(cphi,nlocal,10,"ameoba/mpole:cphi"); + memory->create(fphi,nlocal,20,"ameoba/mpole:fphi"); + + // FFT moduli pre-computations + // set igrid for each atom and its B-spline coeffs + + nfft1 = m_kspace->nx; + nfft2 = m_kspace->ny; + nfft3 = m_kspace->nz; + bsorder = m_kspace->order; + + moduli(); + bspline_fill(); + + // copy multipole info to Cartesian cmp + + for (i = 0; i < nlocal; i++) { + cmp[i][0] = rpole[i][0]; + cmp[i][1] = rpole[i][1]; + cmp[i][2] = rpole[i][2]; + cmp[i][3] = rpole[i][3]; + cmp[i][4] = rpole[i][4]; + cmp[i][5] = rpole[i][8]; + cmp[i][6] = rpole[i][12]; + cmp[i][7] = 2.0 * rpole[i][5]; + cmp[i][8] = 2.0 * rpole[i][6]; + cmp[i][9] = 2.0 * rpole[i][9]; + } + + // convert Cartesian multipoles to fractional multipoles + + cmp_to_fmp(cmp,fmp); + + // gridpre = my portion of 3d grid in brick decomp w/ ghost values + + double ***gridpre = (double ***) m_kspace->zero(); + + // map atoms to grid + + grid_mpole(fmp,gridpre); + + // pre-convolution operations including forward FFT + // gridfft = my portion of complex 3d grid in FFT decomp as 1d vector + + double *gridfft = m_kspace->pre_convolution(); + + // --------------------- + // convolution operation + // --------------------- + + // zero virial accumulation variables + + vxx = vyy = vzz = vxy = vxz = vyz = 0.0; + + // perform convolution on K-space points I own + + nhalf1 = (nfft1+1) / 2; + nhalf2 = (nfft2+1) / 2; + nhalf3 = (nfft3+1) / 2; + + nxlo = m_kspace->nxlo_fft; + nxhi = m_kspace->nxhi_fft; + nylo = m_kspace->nylo_fft; + nyhi = m_kspace->nyhi_fft; + nzlo = m_kspace->nzlo_fft; + nzhi = m_kspace->nzhi_fft; + + pterm = pow((MY_PI/aewald),2.0); + volterm = MY_PI * volbox; + + // printf("bsmod1 %e %e %e %e %e %e \n",bsmod1[0],bsmod1[1],bsmod1[2],bsmod1[3],bsmod1[4],bsmod1[5]); + // printf("bsmod2 %e %e %e %e %e %e \n",bsmod2[0],bsmod2[1],bsmod2[2],bsmod2[3],bsmod2[4],bsmod2[5]); + // printf("bsmod3 %e %e %e %e %e %e \n",bsmod3[0],bsmod3[1],bsmod3[2],bsmod3[3],bsmod3[4],bsmod3[5]); + + n = 0; + for (k = nzlo; k <= nzhi; k++) { + for (j = nylo; j <= nyhi; j++) { + for (i = nxlo; i <= nxhi; i++) { + r1 = (i >= nhalf1) ? i-nfft1 : i; + r2 = (j >= nhalf2) ? j-nfft2 : j; + r3 = (k >= nhalf3) ? k-nfft3 : k; + //printf("ijk %i %i %i r1r2r3 %f %f %f \n",i,j,k,r1,r2,r3); + h1 = recip[0][0]*r1 + recip[0][1]*r2 + recip[0][2]*r3; // matvec + h2 = recip[1][0]*r1 + recip[1][1]*r2 + recip[1][2]*r3; + h3 = recip[2][0]*r1 + recip[2][1]*r2 + recip[2][2]*r3; + hsq = h1*h1 + h2*h2 + h3*h3; + term = -pterm * hsq; + expterm = 0.0; + if (term > -50.0 && hsq != 0.0) { + denom = volterm*hsq*bsmod1[i]*bsmod2[j]*bsmod3[k]; + expterm = exp(term) / denom; + //printf("bsmod %e %e %e expterm %e \n",bsmod1[i],bsmod2[j],bsmod3[k],expterm); + struc2 = gridfft[n]*gridfft[n] + gridfft[n+1]*gridfft[n+1]; + eterm = 0.5 * felec * expterm * struc2; + vterm = (2.0/hsq) * (1.0-term) * eterm; + vxx += h1*h1*vterm - eterm; + vyy += h2*h2*vterm - eterm; + vzz += h3*h3*vterm - eterm; + vxy += h1*h2*vterm; + vxz += h1*h3*vterm; + vyz += h2*h3*vterm; + } + gridfft[n] *= expterm; + gridfft[n+1] *= expterm; + n += 2; + } + } + } + + // save multipole virial for use in polarization computation + + vmsave[0] = vxx; + vmsave[1] = vyy; + vmsave[2] = vzz; + vmsave[3] = vxy; + vmsave[4] = vxz; + vmsave[5] = vyz; + + // post-convolution operations including backward FFT + // gridppost = my portion of 3d grid in brick decomp w/ ghost values + + double ***gridpost = (double ***) m_kspace->post_convolution(); + + // get potential + + fphi_mpole(gridpost,fphi); + + //printf("fphi %e %e %e %e \n",fphi[0][0],fphi[0][1],fphi[0][2],fphi[0][3]); + + for (i = 0; i < nlocal; i++) { + for (k = 0; k < 20; k++) + fphi[i][k] *= felec; + } + //printf("fphi elec %e %e %e %e \n",fphi[0][0],fphi[0][1],fphi[0][2],fphi[0][3]); + + // convert field from fractional to Cartesian + + fphi_to_cphi(fphi,cphi); + + // increment the permanent multipole energy and gradient + + e = 0.0; + for (i = 0; i < nlocal; i++) { + f1 = 0.0; + f2 = 0.0; + f3 = 0.0; + for (k = 0; k < 10; k++) { + e += fmp[i][k]*fphi[i][k]; + f1 += fmp[i][k]*fphi[i][deriv1[k]]; + f2 += fmp[i][k]*fphi[i][deriv2[k]]; + f3 += fmp[i][k]*fphi[i][deriv3[k]]; + } + f1 *= nfft1; + f2 *= nfft2; + f3 *= nfft3; + h1 = recip[0][0]*f1 + recip[0][1]*f2 + recip[0][2]*f3; // matvec? + h2 = recip[1][0]*f1 + recip[1][1]*f2 + recip[1][2]*f3; + h3 = recip[2][0]*f1 + recip[2][1]*f2 + recip[2][2]*f3; + fmpole[i][0] += h1; + fmpole[i][1] += h2; + fmpole[i][2] += h3; + } + empole += 0.5*e; + //printf("mpole_force %g %g %g \n", fmpole[0][0], fmpole[0][1], fmpole[0][2]); + + // augment the permanent multipole virial contributions + + for (i = 0; i < nlocal; i++) { + vxx = vxx - cmp[i][1]*cphi[i][1] - 2.0*cmp[i][4]*cphi[i][4] - + cmp[i][7]*cphi[i][7] - cmp[i][8]*cphi[i][8]; + vxy = vxy - 0.5*(cmp[i][2]*cphi[i][1]+cmp[i][1]*cphi[i][2]) - + (cmp[i][4]+cmp[i][5])*cphi[i][7] - 0.5*cmp[i][7]*(cphi[i][4]+cphi[i][5]) - + 0.5*(cmp[i][8]*cphi[i][9]+cmp[i][9]*cphi[i][8]); + vxz = vxz - 0.5*(cmp[i][3]*cphi[i][1]+cmp[i][1]*cphi[i][3]) - + (cmp[i][4]+cmp[i][6])*cphi[i][8] - 0.5*cmp[i][8]*(cphi[i][4]+cphi[i][6]) - + 0.5*(cmp[i][7]*cphi[i][9]+cmp[i][9]*cphi[i][7]); + vyy = vyy - cmp[i][2]*cphi[i][2] - 2.0*cmp[i][5]*cphi[i][5] - + cmp[i][7]*cphi[i][7] - cmp[i][9]*cphi[i][9]; + vyz = vyz - 0.5*(cmp[i][3]*cphi[i][2]+cmp[i][2]*cphi[i][3]) - + (cmp[i][5]+cmp[i][6])*cphi[i][9] - 0.5*cmp[i][9]*(cphi[i][5]+cphi[i][6]) - + 0.5*(cmp[i][7]*cphi[i][8]+cmp[i][8]*cphi[i][7]); + vzz = vzz - cmp[i][3]*cphi[i][3] - 2.0*cmp[i][6]*cphi[i][6] - + cmp[i][8]*cphi[i][8] - cmp[i][9]*cphi[i][9]; + } + + // resolve site torques then increment forces and virial + + for (i = 0; i < nlocal; i++) { + tem[0] = cmp[i][3]*cphi[i][2] - cmp[i][2]*cphi[i][3] + + 2.0*(cmp[i][6]-cmp[i][5])*cphi[i][9] + + cmp[i][8]*cphi[i][7] + cmp[i][9]*cphi[i][5] - + cmp[i][7]*cphi[i][8] - cmp[i][9]*cphi[i][6]; + tem[1] = cmp[i][1]*cphi[i][3] - cmp[i][3]*cphi[i][1] + + 2.0*(cmp[i][4]-cmp[i][6])*cphi[i][8] + + cmp[i][7]*cphi[i][9] + cmp[i][8]*cphi[i][6] - + cmp[i][8]*cphi[i][4] - cmp[i][9]*cphi[i][7]; + tem[2] = cmp[i][2]*cphi[i][1] - cmp[i][1]*cphi[i][2] + + 2.0*(cmp[i][5]-cmp[i][4])*cphi[i][7] + + cmp[i][7]*cphi[i][4] + cmp[i][9]*cphi[i][8] - + cmp[i][7]*cphi[i][5] - cmp[i][8]*cphi[i][9]; + + torque2force(i,tem,fix,fiy,fiz,fmpole); + + iz = zaxis2local[i]; + ix = xaxis2local[i]; + iy = yaxis2local[i]; + + xiz = x[iz][0] - x[i][0]; + yiz = x[iz][1] - x[i][1]; + ziz = x[iz][2] - x[i][2]; + xix = x[ix][0] - x[i][0]; + yix = x[ix][1] - x[i][1]; + zix = x[ix][2] - x[i][2]; + xiy = x[iy][0] - x[i][0]; + yiy = x[iy][1] - x[i][1]; + ziy = x[iy][2] - x[i][2]; + + vxx += xix*fix[0] + xiy*fiy[0] + xiz*fiz[0]; + vxy += 0.5*(yix*fix[0] + yiy*fiy[0] + yiz*fiz[0] + + xix*fix[1] + xiy*fiy[1] + xiz*fiz[1]); + vxz += 0.5*(zix*fix[0] + ziy*fiy[0] + ziz*fiz[0] + + xix*fix[2] + xiy*fiy[2] + xiz*fiz[2]); + vyy += yix*fix[1] + yiy*fiy[1] + yiz*fiz[1]; + vyz += 0.5*(zix*fix[1] + ziy*fiy[1] + ziz*fiz[1] + + yix*fix[2] + yiy*fiy[2] + yiz*fiz[2]); + vzz += zix*fix[2] + ziy*fiy[2] + ziz*fiz[2]; + } + + // increment total internal virial tensor components + + virmpole[0] += vxx; + virmpole[1] += vyy; + virmpole[2] += vzz; + virmpole[3] += vxy; + virmpole[4] += vxz; + virmpole[5] += vyz; + + // free local memory + + memory->destroy(cmp); + memory->destroy(fmp); + memory->destroy(cphi); + memory->destroy(fphi); +} + +/* ---------------------------------------------------------------------- + damppole generates coefficients for the charge penetration + damping function for powers of the interatomic distance + + literature references: + + L. V. Slipchenko and M. S. Gordon, "Electrostatic Energy in the + Effective Fragment Potential Method: Theory and Application to + the Benzene Dimer", Journal of Computational Chemistry, 28, + 276-291 (2007) [Gordon f1 and f2 models] + + J. A. Rackers, Q. Wang, C. Liu, J.-P. Piquemal, P. Ren and + J. W. Ponder, "An Optimized Charge Penetration Model for Use with + the AMOEBA Force Field", Physical Chemistry Chemical Physics, 19, + 276-291 (2017) +------------------------------------------------------------------------- */ + +void PairAmoeba::damppole(double r, int rorder, double alphai, double alphak, + double *dmpi, double *dmpk, double *dmpik) +{ + double termi,termk; + double termi2,termk2; + double alphai2,alphak2; + double eps,diff; + double expi,expk; + double dampi,dampk; + double dampi2,dampi3; + double dampi4,dampi5; + double dampi6,dampi7; + double dampi8; + double dampk2,dampk3; + double dampk4,dampk5; + double dampk6; + + // compute tolerance and exponential damping factors + + eps = 0.001; + diff = fabs(alphai-alphak); + dampi = alphai * r; + dampk = alphak * r; + expi = exp(-dampi); + expk = exp(-dampk); + + // core-valence charge penetration damping for Gordon f1 + + dampi2 = dampi * dampi; + dampi3 = dampi * dampi2; + dampi4 = dampi2 * dampi2; + dampi5 = dampi2 * dampi3; + dmpi[0] = 1.0 - (1.0 + 0.5*dampi)*expi; + dmpi[2] = 1.0 - (1.0 + dampi + 0.5*dampi2)*expi; + dmpi[4] = 1.0 - (1.0 + dampi + 0.5*dampi2 + dampi3/6.0)*expi; + dmpi[6] = 1.0 - (1.0 + dampi + 0.5*dampi2 + dampi3/6.0 + dampi4/30.0)*expi; + dmpi[8] = 1.0 - (1.0 + dampi + 0.5*dampi2 + dampi3/6.0 + + 4.0*dampi4/105.0 + dampi5/210.0)*expi; + if (diff < eps) { + dmpk[0] = dmpi[0]; + dmpk[2] = dmpi[2]; + dmpk[4] = dmpi[4]; + dmpk[6] = dmpi[6]; + dmpk[8] = dmpi[8]; + } else { + dampk2 = dampk * dampk; + dampk3 = dampk * dampk2; + dampk4 = dampk2 * dampk2; + dampk5 = dampk2 * dampk3; + dmpk[0] = 1.0 - (1.0 + 0.5*dampk)*expk; + dmpk[2] = 1.0 - (1.0 + dampk + 0.5*dampk2)*expk; + dmpk[4] = 1.0 - (1.0 + dampk + 0.5*dampk2 + dampk3/6.0)*expk; + dmpk[6] = 1.0 - (1.0 + dampk + 0.5*dampk2 + dampk3/6.0 + dampk4/30.0)*expk; + dmpk[8] = 1.0 - (1.0 + dampk + 0.5*dampk2 + dampk3/6.0 + + 4.0*dampk4/105.0 + dampk5/210.0)*expk; + } + + // valence-valence charge penetration damping for Gordon f1 + + if (diff < eps) { + dampi6 = dampi3 * dampi3; + dampi7 = dampi3 * dampi4; + dmpik[0] = 1.0 - (1.0 + 11.0*dampi/16.0 + 3.0*dampi2/16.0 + + dampi3/48.0)*expi; + dmpik[2] = 1.0 - (1.0 + dampi + 0.5*dampi2 + + 7.0*dampi3/48.0 + dampi4/48.0)*expi; + dmpik[4] = 1.0 - (1.0 + dampi + 0.5*dampi2 + dampi3/6.0 + + dampi4/24.0 + dampi5/144.0)*expi; + dmpik[6] = 1.0 - (1.0 + dampi + 0.5*dampi2 + dampi3/6.0 + + dampi4/24.0 + dampi5/120.0 + dampi6/720.0)*expi; + dmpik[8] = 1.0 - (1.0 + dampi + 0.5*dampi2 + dampi3/6.0 + + dampi4/24.0 + dampi5/120.0 + dampi6/720.0 + + dampi7/5040.0)*expi; + if (rorder >= 11) { + dampi8 = dampi4 * dampi4; + dmpik[10] = 1.0 - (1.0 + dampi + 0.5*dampi2 + dampi3/6.0 + + dampi4/24.0 + dampi5/120.0 + dampi6/720.0 + + dampi7/5040.0 + dampi8/45360.0)*expi; + } + + } else { + alphai2 = alphai * alphai; + alphak2 = alphak * alphak; + termi = alphak2 / (alphak2-alphai2); + termk = alphai2 / (alphai2-alphak2); + termi2 = termi * termi; + termk2 = termk * termk; + dmpik[0] = 1.0 - termi2*(1.0 + 2.0*termk + 0.5*dampi)*expi - + termk2*(1.0 + 2.0*termi + 0.5*dampk)*expk; + dmpik[2] = 1.0 - termi2*(1.0+dampi+0.5*dampi2)*expi - + termk2*(1.0+dampk+0.5*dampk2)*expk - + 2.0*termi2*termk*(1.0+dampi)*expi - + 2.0*termk2*termi*(1.0+dampk)*expk; + dmpik[4] = 1.0 - termi2*(1.0 + dampi + 0.5*dampi2 + dampi3/6.0)*expi - + termk2*(1.0 + dampk + 0.5*dampk2 + dampk3/6.0)*expk - + 2.0*termi2*termk*(1.0 + dampi + dampi2/3.0)*expi - + 2.0*termk2*termi*(1.0 + dampk + dampk2/3.0)*expk; + dmpik[6] = 1.0 - termi2*(1.0 + dampi + 0.5*dampi2 + + dampi3/6.0 + dampi4/30.0)*expi - + termk2*(1.0 + dampk + 0.5*dampk2 + dampk3/6.0 + dampk4/30.0)*expk - + 2.0*termi2*termk*(1.0 + dampi + 2.0*dampi2/5.0 + dampi3/15.0)*expi - + 2.0*termk2*termi*(1.0 + dampk + 2.0*dampk2/5.0 + dampk3/15.0)*expk; + dmpik[8] = 1.0 - termi2*(1.0 + dampi + 0.5*dampi2 + dampi3/6.0 + + 4.0*dampi4/105.0 + dampi5/210.0)*expi - + termk2*(1.0 + dampk + 0.5*dampk2 + dampk3/6.0 + + 4.0*dampk4/105.0 + dampk5/210.0)*expk - + 2.0*termi2*termk*(1.0 + dampi + 3.0*dampi2/7.0 + + 2.0*dampi3/21.0 + dampi4/105.0)*expi - + 2.0*termk2*termi*(1.0 + dampk + 3.0*dampk2/7.0 + + 2.0*dampk3/21.0 + dampk4/105.0)*expk; + + if (rorder >= 11) { + dampi6 = dampi3 * dampi3; + dampk6 = dampk3 * dampk3; + dmpik[10] = 1.0 - termi2*(1.0 + dampi + 0.5*dampi2 + dampi3/6.0 + + 5.0*dampi4/126.0 + 2.0*dampi5/315.0 + + dampi6/1890.0)*expi - + termk2*(1.0 + dampk + 0.5*dampk2 + dampk3/6.0 + 5.0*dampk4/126.0 + + 2.0*dampk5/315.0 + dampk6/1890.0)*expk - + 2.0*termi2*termk*(1.0 + dampi + 4.0*dampi2/9.0 + dampi3/9.0 + + dampi4/63.0 + dampi5/945.0)*expi - + 2.0*termk2*termi*(1.0 + dampk + 4.0*dampk2/9.0 + dampk3/9.0 + + dampk4/63.0 + dampk5/945.0)*expk; + } + } +} diff --git a/src/AMOEBA/amoeba_polar.cpp b/src/AMOEBA/amoeba_polar.cpp new file mode 100644 index 0000000000..1503243220 --- /dev/null +++ b/src/AMOEBA/amoeba_polar.cpp @@ -0,0 +1,2224 @@ +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#include "pair_amoeba.h" +#include +#include +#include "amoeba_convolution.h" +#include "atom.h" +#include "domain.h" +#include "comm.h" +#include "neigh_list.h" +#include "fft3d_wrap.h" +#include "math_const.h" +#include "memory.h" + +// DEBUG + +#include "error.h" + +using namespace LAMMPS_NS; +using namespace MathConst; + +enum{FIELD,ZRSD,TORQUE,UFLD}; // reverse comm +enum{MUTUAL,OPT,TCG,DIRECT}; +enum{VDWL,REPULSE,QFER,DISP,MPOLE,POLAR,USOLV,DISP_LONG,MPOLE_LONG,POLAR_LONG}; + +/* ---------------------------------------------------------------------- + polar = induced dipole polarization + adapted from Tinker epolar1d() routine +------------------------------------------------------------------------- */ + +void PairAmoeba::polar() +{ + int i,j,ii; + int ix,iy,iz; + double felec,term; + double dix,diy,diz; + double uix,uiy,uiz; + double xd,yd,zd; + double xq,yq,zq; + double xu,yu,zu; + double xup,yup,zup; + double xv,yv,zv,vterm; + double xufield,yufield,zufield; + double xix,yix,zix; + double xiy,yiy,ziy; + double xiz,yiz,ziz; + double vxx,vyy,vzz; + double vxy,vxz,vyz; + double fix[3],fiy[3],fiz[3]; + double tep[3]; + + // set cutoffs, taper coeffs, and PME params + + if (use_ewald) choose(POLAR_LONG); + else choose(POLAR); + + // owned atoms + + double **x = atom->x; + int nlocal = atom->nlocal; + + // set the energy unit conversion factor + + felec = electric / am_dielectric; + + // compute the total induced dipole polarization energy + + polar_energy(); + + // compute the real space part of the dipole interactions + + if (rspace_flag) polar_real(); + + // compute the reciprocal space part of dipole interactions + + if (kspace_flag) polar_kspace(); + + // compute the Ewald self-energy torque and virial terms + + term = (4.0/3.0) * felec * pow(aewald,3.0) / MY_PIS; + + for (i = 0; i < nlocal; i++) { + dix = rpole[i][1]; + diy = rpole[i][2]; + diz = rpole[i][3]; + uix = 0.5 * (uind[i][0]+uinp[i][0]); + uiy = 0.5 * (uind[i][1]+uinp[i][1]); + uiz = 0.5 * (uind[i][2]+uinp[i][2]); + tep[0] = term * (diy*uiz-diz*uiy); + tep[1] = term * (diz*uix-dix*uiz); + tep[2] = term * (dix*uiy-diy*uix); + + torque2force(i,tep,fix,fiy,fiz,fpolar); + + iz = zaxis2local[i]; + ix = xaxis2local[i]; + iy = yaxis2local[i]; + + xiz = x[iz][0] - x[i][0]; + yiz = x[iz][1] - x[i][1]; + ziz = x[iz][2] - x[i][2]; + xix = x[ix][0] - x[i][0]; + yix = x[ix][1] - x[i][1]; + zix = x[ix][2] - x[i][2]; + xiy = x[iy][0] - x[i][0]; + yiy = x[iy][1] - x[i][1]; + ziy = x[iy][2] - x[i][2]; + + vxx = xix*fix[0] + xiy*fiy[0] + xiz*fiz[0]; + vyy = yix*fix[1] + yiy*fiy[1] + yiz*fiz[1]; + vzz = zix*fix[2] + ziy*fiy[2] + ziz*fiz[2]; + + vxy = 0.5 * (yix*fix[0] + yiy*fiy[0] + yiz*fiz[0] + + xix*fix[1] + xiy*fiy[1] + xiz*fiz[1]); + vxz = 0.5 * (zix*fix[0] + ziy*fiy[0] + ziz*fiz[0] + + xix*fix[2] + xiy*fiy[2] + xiz*fiz[2]); + vyz = 0.5 * (zix*fix[1] + ziy*fiy[1] + ziz*fiz[1] + + yix*fix[2] + yiy*fiy[2] + yiz*fiz[2]); + + virpolar[0] += vxx; + virpolar[1] += vyy; + virpolar[2] += vzz; + virpolar[3] += vxy; + virpolar[4] += vxz; + virpolar[5] += vyz; + } + + // clean up + // qfac was allocated in induce + + if (use_ewald) memory->destroy(qfac); +} + +/* ---------------------------------------------------------------------- + polar_energy = inducded dipole polarization energy + adapted from Tinker epolar1e() routine +------------------------------------------------------------------------- */ + +void PairAmoeba::polar_energy() +{ + int i,j,ii,itype; + double e,felec,fi,term; + double xd,yd,zd; + double xu,yu,zu; + double dix,diy,diz; + double uix,uiy,uiz; + + // owned atoms + + double **x = atom->x; + int nlocal = atom->nlocal; + + // set the energy unit conversion factor + + felec = -0.5 * electric / am_dielectric; + + // get polarization energy via induced dipoles times field + + for (i = 0; i < nlocal; i++) { + itype = amtype[i]; + fi = felec / polarity[itype]; + e = 0.0; + for (j = 0; j < 3; j++) + e += fi*uind[i][j]*udirp[i][j]; + epolar += e; + } +} + +/* ---------------------------------------------------------------------- + polar_real = real-space portion of induced dipole polarization + adapted from Tinker epreal1d() routine +------------------------------------------------------------------------- */ + +void PairAmoeba::polar_real() +{ + int i,j,k,m,ii,jj,jextra,itype,jtype,iclass,jclass,igroup,jgroup; + int ix,iy,iz; + double felec,bfac; + double alsq2,alsq2n; + double exp2a,ralpha; + double damp,expdamp; + double pdi,pti,ddi; + double pgamma; + double temp3,temp5,temp7; + double sc3,sc5,sc7; + double psc3,psc5,psc7; + double dsc3,dsc5,dsc7; + double usc3,usc5; + double psr3,psr5,psr7; + double dsr3,dsr5,dsr7; + double usr3,usr5; + double rr3core,rr5core; + double rr3i,rr5i; + double rr7i,rr9i; + double rr3k,rr5k; + double rr7k,rr9k; + double rr5ik,rr7ik; + double xi,yi,zi; + double xr,yr,zr; + double r,r2,rr1,rr3; + double rr5,rr7,rr9; + double ci,dix,diy,diz; + double qixx,qixy,qixz; + double qiyy,qiyz,qizz; + double uix,uiy,uiz; + double uixp,uiyp,uizp; + double ck,dkx,dky,dkz; + double qkxx,qkxy,qkxz; + double qkyy,qkyz,qkzz; + double ukx,uky,ukz; + double ukxp,ukyp,ukzp; + double dir,uir,uirp; + double dkr,ukr,ukrp; + double qix,qiy,qiz,qir; + double qkx,qky,qkz,qkr; + double corei,corek; + double vali,valk; + double alphai,alphak; + double uirm,ukrm; + double uirt,ukrt; + double tuir,tukr; + double tixx,tiyy,tizz; + double tixy,tixz,tiyz; + double tkxx,tkyy,tkzz; + double tkxy,tkxz,tkyz; + double tix3,tiy3,tiz3; + double tix5,tiy5,tiz5; + double tkx3,tky3,tkz3; + double tkx5,tky5,tkz5; + double term1,term2,term3; + double term4,term5; + double term6,term7; + double term1core; + double term1i,term2i,term3i; + double term4i,term5i,term6i; + double term7i,term8i; + double term1k,term2k,term3k; + double term4k,term5k,term6k; + double term7k,term8k; + double depx,depy,depz; + double frcx,frcy,frcz; + double xix,yix,zix; + double xiy,yiy,ziy; + double xiz,yiz,ziz; + double vxx,vyy,vzz; + double vxy,vxz,vyz; + double factor_pscale,factor_dscale,factor_uscale,factor_wscale; + double rc3[3],rc5[3],rc7[3]; + double prc3[3],prc5[3],prc7[3]; + double drc3[3],drc5[3],drc7[3]; + double urc3[3],urc5[3],tep[3]; + double fix[3],fiy[3],fiz[3]; + double uax[3],uay[3],uaz[3]; + double ubx[3],uby[3],ubz[3]; + double uaxp[3],uayp[3],uazp[3]; + double ubxp[3],ubyp[3],ubzp[3]; + double dmpi[9],dmpk[9]; + double dmpik[9]; + double bn[5]; + + int inum,jnum; + int *ilist,*jlist,*numneigh,**firstneigh; + + // owned atoms + + pval = atom->dvector[index_pval]; + + double **x = atom->x; + int nlocal = atom->nlocal; + int nall = nlocal + atom->nghost; + + // initialize ufld,dulfd to zero for owned and ghost atoms + + for (i = 0; i < nall; i++) + for (j = 0; j < 3; j++) + ufld[i][j] = 0.0; + + for (i = 0; i < nall; i++) + for (j = 0; j < 6; j++) + dufld[i][j] = 0.0; + + // neigh list + + inum = list->inum; + ilist = list->ilist; + numneigh = list->numneigh; + firstneigh = list->firstneigh; + + // set the energy unit conversion factor + // NOTE: why 1/2 ? + + felec = 0.5 * electric / am_dielectric; + + // compute the dipole polarization gradient components + + for (ii = 0; ii < inum; ii++) { + i = ilist[ii]; + itype = amtype[i]; + iclass = amtype2class[itype]; + igroup = amgroup[i]; + jlist = firstneigh[i]; + jnum = numneigh[i]; + + xi = x[i][0]; + yi = x[i][1]; + zi = x[i][2]; + ci = rpole[i][0]; + dix = rpole[i][1]; + diy = rpole[i][2]; + diz = rpole[i][3]; + qixx = rpole[i][4]; + qixy = rpole[i][5]; + qixz = rpole[i][6]; + qiyy = rpole[i][8]; + qiyz = rpole[i][9]; + qizz = rpole[i][12]; + uix = uind[i][0]; + uiy = uind[i][1]; + uiz = uind[i][2]; + uixp = uinp[i][0]; + uiyp = uinp[i][1]; + uizp = uinp[i][2]; + for (m = 0; m < tcgnab; m++) { + uax[m] = uad[m][i][0]; + uay[m] = uad[m][i][1]; + uaz[m] = uad[m][i][2]; + uaxp[m] = uap[m][i][0]; + uayp[m] = uap[m][i][1]; + uazp[m] = uap[m][i][2]; + ubx[m] = ubd[m][i][0]; + uby[m] = ubd[m][i][1]; + ubz[m] = ubd[m][i][2]; + ubxp[m] = ubp[m][i][0]; + ubyp[m] = ubp[m][i][1]; + ubzp[m] = ubp[m][i][2]; + } + + if (amoeba) { + pdi = pdamp[itype]; + pti = thole[itype]; + ddi = dirdamp[itype]; + } else if (hippo) { + corei = pcore[iclass]; + alphai = palpha[iclass]; + vali = pval[i]; + } + + // evaluate all sites within the cutoff distance + + for (jj = 0; jj < jnum; jj++) { + jextra = jlist[jj]; + j = jextra & NEIGHMASK15; + + xr = x[j][0] - xi; + yr = x[j][1] - yi; + zr = x[j][2] - zi; + r2 = xr*xr + yr*yr + zr*zr; + if (r2 > off2) continue; + + jtype = amtype[j]; + jclass = amtype2class[jtype]; + jgroup = amgroup[j]; + + if (amoeba) { + factor_wscale = special_polar_wscale[sbmask15(jextra)]; + if (igroup == jgroup) { + factor_pscale = special_polar_piscale[sbmask15(jextra)]; + factor_dscale = polar_dscale; + factor_uscale = polar_uscale; + } else { + factor_pscale = special_polar_pscale[sbmask15(jextra)]; + factor_dscale = factor_uscale = 1.0; + } + + } else if (hippo) { + factor_wscale = special_polar_wscale[sbmask15(jextra)]; + if (igroup == jgroup) { + factor_dscale = factor_pscale = special_polar_piscale[sbmask15(jextra)]; + factor_uscale = polar_uscale; + } else { + factor_dscale = factor_pscale = special_polar_pscale[sbmask15(jextra)]; + factor_uscale = 1.0; + } + } + + r = sqrt(r2); + ck = rpole[j][0]; + dkx = rpole[j][1]; + dky = rpole[j][2]; + dkz = rpole[j][3]; + qkxx = rpole[j][4]; + qkxy = rpole[j][5]; + qkxz = rpole[j][6]; + qkyy = rpole[j][8]; + qkyz = rpole[j][9]; + qkzz = rpole[j][12]; + ukx = uind[j][0]; + uky = uind[j][1]; + ukz = uind[j][2]; + ukxp = uinp[j][0]; + ukyp = uinp[j][1]; + ukzp = uinp[j][2]; + + // intermediates involving moments and separation distance + + dir = dix*xr + diy*yr + diz*zr; + qix = qixx*xr + qixy*yr + qixz*zr; + qiy = qixy*xr + qiyy*yr + qiyz*zr; + qiz = qixz*xr + qiyz*yr + qizz*zr; + qir = qix*xr + qiy*yr + qiz*zr; + dkr = dkx*xr + dky*yr + dkz*zr; + qkx = qkxx*xr + qkxy*yr + qkxz*zr; + qky = qkxy*xr + qkyy*yr + qkyz*zr; + qkz = qkxz*xr + qkyz*yr + qkzz*zr; + qkr = qkx*xr + qky*yr + qkz*zr; + uir = uix*xr + uiy*yr + uiz*zr; + uirp = uixp*xr + uiyp*yr + uizp*zr; + ukr = ukx*xr + uky*yr + ukz*zr; + ukrp = ukxp*xr + ukyp*yr + ukzp*zr; + + // get reciprocal distance terms for this interaction + + rr1 = felec / r; + rr3 = rr1 / r2; + rr5 = 3.0 * rr3 / r2; + rr7 = 5.0 * rr5 / r2; + rr9 = 7.0 * rr7 / r2; + + // calculate the real space Ewald error function terms + + ralpha = aewald * r; + bn[0] = erfc(ralpha) / r; + alsq2 = 2.0 * aewald*aewald; + alsq2n = 0.0; + if (aewald > 0.0) alsq2n = 1.0 / (MY_PIS*aewald); + exp2a = exp(-ralpha*ralpha); + + for (m = 1; m <= 4; m++) { + bfac = (double) (m+m-1); + alsq2n = alsq2 * alsq2n; + bn[m] = (bfac*bn[m-1]+alsq2n*exp2a) / r2; + } + for (m = 0; m < 5; m++) bn[m] *= felec; + + // apply Thole polarization damping to scale factors + + sc3 = 1.0; + sc5 = 1.0; + sc7 = 1.0; + for (k = 0; k < 3; k++) { + rc3[k] = 0.0; + rc5[k] = 0.0; + rc7[k] = 0.0; + } + + // apply Thole polarization damping to scale factors + + if (amoeba) { + damp = pdi * pdamp[jtype]; + if (damp != 0.0) { + pgamma = MIN(pti,thole[jtype]); + damp = pgamma * pow(r/damp,3.0); + if (damp < 50.0) { + expdamp = exp(-damp); + sc3 = 1.0 - expdamp; + sc5 = 1.0 - (1.0+damp)*expdamp; + sc7 = 1.0 - (1.0+damp+0.6*damp*damp) * expdamp; + temp3 = 3.0 * damp * expdamp / r2; + temp5 = damp; + temp7 = -0.2 + 0.6*damp; + rc3[0] = xr * temp3; + rc3[1] = yr * temp3; + rc3[2] = zr * temp3; + rc5[0] = rc3[0] * temp5; + rc5[1] = rc3[1] * temp5; + rc5[2] = rc3[2] * temp5; + rc7[0] = rc5[0] * temp7; + rc7[1] = rc5[1] * temp7; + rc7[2] = rc5[2] * temp7; + } + + psc3 = 1.0 - sc3*factor_pscale; + psc5 = 1.0 - sc5*factor_pscale; + psc7 = 1.0 - sc7*factor_pscale; + dsc3 = 1.0 - sc3*factor_dscale; + dsc5 = 1.0 - sc5*factor_dscale; + dsc7 = 1.0 - sc7*factor_dscale; + usc3 = 1.0 - sc3*factor_uscale; + usc5 = 1.0 - sc5*factor_uscale; + psr3 = bn[1] - psc3*rr3; + psr5 = bn[2] - psc5*rr5; + psr7 = bn[3] - psc7*rr7; + dsr3 = bn[1] - dsc3*rr3; + dsr5 = bn[2] - dsc5*rr5; + dsr7 = bn[3] - dsc7*rr7; + usr3 = bn[1] - usc3*rr3; + usr5 = bn[2] - usc5*rr5; + for (k = 0; k < 3; k++) { + prc3[k] = rc3[k] * factor_pscale; + prc5[k] = rc5[k] * factor_pscale; + prc7[k] = rc7[k] * factor_pscale; + drc3[k] = rc3[k] * factor_dscale; + drc5[k] = rc5[k] * factor_dscale; + drc7[k] = rc7[k] * factor_dscale; + urc3[k] = rc3[k] * factor_uscale; + urc5[k] = rc5[k] * factor_uscale; + } + } + + // apply charge penetration damping to scale factors + + } else if (hippo) { + corek = pcore[jclass]; + alphak = palpha[jclass]; + valk = pval[j]; + damppole(r,9,alphai,alphak,dmpi,dmpk,dmpik); + rr3core = bn[1] - (1.0-factor_dscale)*rr3; + rr5core = bn[2] - (1.0-factor_dscale)*rr5; + rr3i = bn[1] - (1.0-factor_dscale*dmpi[2])*rr3; + rr5i = bn[2] - (1.0-factor_dscale*dmpi[4])*rr5; + rr7i = bn[3] - (1.0-factor_dscale*dmpi[6])*rr7; + rr9i = bn[4] - (1.0-factor_dscale*dmpi[8])*rr9; + rr3k = bn[1] - (1.0-factor_dscale*dmpk[2])*rr3; + rr5k = bn[2] - (1.0-factor_dscale*dmpk[4])*rr5; + rr7k = bn[3] - (1.0-factor_dscale*dmpk[6])*rr7; + rr9k = bn[4] - (1.0-factor_dscale*dmpk[8])*rr9; + rr5ik = bn[2] - (1.0-factor_wscale*dmpik[4])*rr5; + rr7ik = bn[3] - (1.0-factor_wscale*dmpik[6])*rr7; + } + + // get the induced dipole field used for dipole torques + + if (amoeba) { + tix3 = psr3*ukx + dsr3*ukxp; + tiy3 = psr3*uky + dsr3*ukyp; + tiz3 = psr3*ukz + dsr3*ukzp; + tkx3 = psr3*uix + dsr3*uixp; + tky3 = psr3*uiy + dsr3*uiyp; + tkz3 = psr3*uiz + dsr3*uizp; + tuir = -psr5*ukr - dsr5*ukrp; + tukr = -psr5*uir - dsr5*uirp; + } else if (hippo) { + tix3 = 2.0*rr3i*ukx; + tiy3 = 2.0*rr3i*uky; + tiz3 = 2.0*rr3i*ukz; + tkx3 = 2.0*rr3k*uix; + tky3 = 2.0*rr3k*uiy; + tkz3 = 2.0*rr3k*uiz; + tuir = -2.0*rr5i*ukr; + tukr = -2.0*rr5k*uir; + } + + ufld[i][0] += tix3 + xr*tuir; + ufld[i][1] += tiy3 + yr*tuir; + ufld[i][2] += tiz3 + zr*tuir; + ufld[j][0] += tkx3 + xr*tukr; + ufld[j][1] += tky3 + yr*tukr; + ufld[j][2] += tkz3 + zr*tukr; + + // get induced dipole field gradient used for quadrupole torques + + if (amoeba) { + tix5 = 2.0 * (psr5*ukx+dsr5*ukxp); + tiy5 = 2.0 * (psr5*uky+dsr5*ukyp); + tiz5 = 2.0 * (psr5*ukz+dsr5*ukzp); + tkx5 = 2.0 * (psr5*uix+dsr5*uixp); + tky5 = 2.0 * (psr5*uiy+dsr5*uiyp); + tkz5 = 2.0 * (psr5*uiz+dsr5*uizp); + tuir = -psr7*ukr - dsr7*ukrp; + tukr = -psr7*uir - dsr7*uirp; + + } else if (hippo) { + tix5 = 4.0 * (rr5i*ukx); + tiy5 = 4.0 * (rr5i*uky); + tiz5 = 4.0 * (rr5i*ukz); + tkx5 = 4.0 * (rr5k*uix); + tky5 = 4.0 * (rr5k*uiy); + tkz5 = 4.0 * (rr5k*uiz); + tuir = -2.0*rr7i*ukr; + tukr = -2.0*rr7k*uir; + } + + dufld[i][0] += xr*tix5 + xr*xr*tuir; + dufld[i][1] += xr*tiy5 + yr*tix5 + 2.0*xr*yr*tuir; + dufld[i][2] += yr*tiy5 + yr*yr*tuir; + dufld[i][3] += xr*tiz5 + zr*tix5 + 2.0*xr*zr*tuir; + dufld[i][4] += yr*tiz5 + zr*tiy5 + 2.0*yr*zr*tuir; + dufld[i][5] += zr*tiz5 + zr*zr*tuir; + + dufld[j][0] -= xr*tkx5 + xr*xr*tukr; + dufld[j][1] -= xr*tky5 + yr*tkx5 + 2.0*xr*yr*tukr; + dufld[j][2] -= yr*tky5 + yr*yr*tukr; + dufld[j][3] -= xr*tkz5 + zr*tkx5 + 2.0*xr*zr*tukr; + dufld[j][4] -= yr*tkz5 + zr*tky5 + 2.0*yr*zr*tukr; + dufld[j][5] -= zr*tkz5 + zr*zr*tukr; + + // get the dEd/dR terms used for direct polarization force + + if (amoeba) { + term1 = bn[2] - dsc3*rr5; + term2 = bn[3] - dsc5*rr7; + term3 = -dsr3 + term1*xr*xr - rr3*xr*drc3[0]; + term4 = rr3*drc3[0] - term1*xr - dsr5*xr; + term5 = term2*xr*xr - dsr5 - rr5*xr*drc5[0]; + term6 = (bn[4]-dsc7*rr9)*xr*xr - bn[3] - rr7*xr*drc7[0]; + term7 = rr5*drc5[0] - 2.0*bn[3]*xr + (dsc5+1.5*dsc7)*rr7*xr; + tixx = ci*term3 + dix*term4 + dir*term5 + + 2.0*dsr5*qixx + (qiy*yr+qiz*zr)*dsc7*rr7 + 2.0*qix*term7 + qir*term6; + tkxx = ck*term3 - dkx*term4 - dkr*term5 + + 2.0*dsr5*qkxx + (qky*yr+qkz*zr)*dsc7*rr7 + 2.0*qkx*term7 + qkr*term6; + term3 = -dsr3 + term1*yr*yr - rr3*yr*drc3[1]; + term4 = rr3*drc3[1] - term1*yr - dsr5*yr; + term5 = term2*yr*yr - dsr5 - rr5*yr*drc5[1]; + term6 = (bn[4]-dsc7*rr9)*yr*yr - bn[3] - rr7*yr*drc7[1]; + term7 = rr5*drc5[1] - 2.0*bn[3]*yr + (dsc5+1.5*dsc7)*rr7*yr; + tiyy = ci*term3 + diy*term4 + dir*term5 + + 2.0*dsr5*qiyy + (qix*xr+qiz*zr)*dsc7*rr7 + 2.0*qiy*term7 + qir*term6; + tkyy = ck*term3 - dky*term4 - dkr*term5 + + 2.0*dsr5*qkyy + (qkx*xr+qkz*zr)*dsc7*rr7 + 2.0*qky*term7 + qkr*term6; + term3 = -dsr3 + term1*zr*zr - rr3*zr*drc3[2]; + term4 = rr3*drc3[2] - term1*zr - dsr5*zr; + term5 = term2*zr*zr - dsr5 - rr5*zr*drc5[2]; + term6 = (bn[4]-dsc7*rr9)*zr*zr - bn[3] - rr7*zr*drc7[2]; + term7 = rr5*drc5[2] - 2.0*bn[3]*zr + (dsc5+1.5*dsc7)*rr7*zr; + tizz = ci*term3 + diz*term4 + dir*term5 + + 2.0*dsr5*qizz + (qix*xr+qiy*yr)*dsc7*rr7 + 2.0*qiz*term7 + qir*term6; + tkzz = ck*term3 - dkz*term4 - dkr*term5 + + 2.0*dsr5*qkzz + (qkx*xr+qky*yr)*dsc7*rr7 + 2.0*qkz*term7 + qkr*term6; + term3 = term1*xr*yr - rr3*yr*drc3[0]; + term4 = rr3*drc3[0] - term1*xr; + term5 = term2*xr*yr - rr5*yr*drc5[0]; + term6 = (bn[4]-dsc7*rr9)*xr*yr - rr7*yr*drc7[0]; + term7 = rr5*drc5[0] - term2*xr; + tixy = ci*term3 - dsr5*dix*yr + diy*term4 + dir*term5 + + 2.0*dsr5*qixy - 2.0*dsr7*yr*qix + 2.0*qiy*term7 + qir*term6; + tkxy = ck*term3 + dsr5*dkx*yr - dky*term4 - dkr*term5 + + 2.0*dsr5*qkxy - 2.0*dsr7*yr*qkx + 2.0*qky*term7 + qkr*term6; + term3 = term1*xr*zr - rr3*zr*drc3[0]; + term5 = term2*xr*zr - rr5*zr*drc5[0]; + term6 = (bn[4]-dsc7*rr9)*xr*zr - rr7*zr*drc7[0]; + tixz = ci*term3 - dsr5*dix*zr + diz*term4 + dir*term5 + + 2.0*dsr5*qixz - 2.0*dsr7*zr*qix + 2.0*qiz*term7 + qir*term6; + tkxz = ck*term3 + dsr5*dkx*zr - dkz*term4 - dkr*term5 + + 2.0*dsr5*qkxz - 2.0*dsr7*zr*qkx + 2.0*qkz*term7 + qkr*term6; + term3 = term1*yr*zr - rr3*zr*drc3[1]; + term4 = rr3*drc3[1] - term1*yr; + term5 = term2*yr*zr - rr5*zr*drc5[1]; + term6 = (bn[4]-dsc7*rr9)*yr*zr - rr7*zr*drc7[1]; + term7 = rr5*drc5[1] - term2*yr; + tiyz = ci*term3 - dsr5*diy*zr + diz*term4 + dir*term5 + + 2.0*dsr5*qiyz - 2.0*dsr7*zr*qiy + 2.0*qiz*term7 + qir*term6; + tkyz = ck*term3 + dsr5*dky*zr - dkz*term4 - dkr*term5 + + 2.0*dsr5*qkyz - 2.0*dsr7*zr*qky + 2.0*qkz*term7 + qkr*term6; + depx = tixx*ukxp + tixy*ukyp + tixz*ukzp - tkxx*uixp - tkxy*uiyp - tkxz*uizp; + depy = tixy*ukxp + tiyy*ukyp + tiyz*ukzp - tkxy*uixp - tkyy*uiyp - tkyz*uizp; + depz = tixz*ukxp + tiyz*ukyp + tizz*ukzp - tkxz*uixp - tkyz*uiyp - tkzz*uizp; + frcx = depx; + frcy = depy; + frcz = depz; + + // get the dEp/dR terms used for direct polarization force + + term1 = bn[2] - psc3*rr5; + term2 = bn[3] - psc5*rr7; + term3 = -psr3 + term1*xr*xr - rr3*xr*prc3[0]; + term4 = rr3*prc3[0] - term1*xr - psr5*xr; + term5 = term2*xr*xr - psr5 - rr5*xr*prc5[0]; + term6 = (bn[4]-psc7*rr9)*xr*xr - bn[3] - rr7*xr*prc7[0]; + term7 = rr5*prc5[0] - 2.0*bn[3]*xr + (psc5+1.5*psc7)*rr7*xr; + tixx = ci*term3 + dix*term4 + dir*term5 + + 2.0*psr5*qixx + (qiy*yr+qiz*zr)*psc7*rr7 + 2.0*qix*term7 + qir*term6; + tkxx = ck*term3 - dkx*term4 - dkr*term5 + + 2.0*psr5*qkxx + (qky*yr+qkz*zr)*psc7*rr7 + 2.0*qkx*term7 + qkr*term6; + term3 = -psr3 + term1*yr*yr - rr3*yr*prc3[1]; + term4 = rr3*prc3[1] - term1*yr - psr5*yr; + term5 = term2*yr*yr - psr5 - rr5*yr*prc5[1]; + term6 = (bn[4]-psc7*rr9)*yr*yr - bn[3] - rr7*yr*prc7[1]; + term7 = rr5*prc5[1] - 2.0*bn[3]*yr + (psc5+1.5*psc7)*rr7*yr; + tiyy = ci*term3 + diy*term4 + dir*term5 + + 2.0*psr5*qiyy + (qix*xr+qiz*zr)*psc7*rr7 + 2.0*qiy*term7 + qir*term6; + tkyy = ck*term3 - dky*term4 - dkr*term5 + + 2.0*psr5*qkyy + (qkx*xr+qkz*zr)*psc7*rr7 + 2.0*qky*term7 + qkr*term6; + term3 = -psr3 + term1*zr*zr - rr3*zr*prc3[2]; + term4 = rr3*prc3[2] - term1*zr - psr5*zr; + term5 = term2*zr*zr - psr5 - rr5*zr*prc5[2]; + term6 = (bn[4]-psc7*rr9)*zr*zr - bn[3] - rr7*zr*prc7[2]; + term7 = rr5*prc5[2] - 2.0*bn[3]*zr + (psc5+1.5*psc7)*rr7*zr; + tizz = ci*term3 + diz*term4 + dir*term5 + + 2.0*psr5*qizz + (qix*xr+qiy*yr)*psc7*rr7 + 2.0*qiz*term7 + qir*term6; + tkzz = ck*term3 - dkz*term4 - dkr*term5 + + 2.0*psr5*qkzz + (qkx*xr+qky*yr)*psc7*rr7 + 2.0*qkz*term7 + qkr*term6; + term3 = term1*xr*yr - rr3*yr*prc3[0]; + term4 = rr3*prc3[0] - term1*xr; + term5 = term2*xr*yr - rr5*yr*prc5[0]; + term6 = (bn[4]-psc7*rr9)*xr*yr - rr7*yr*prc7[0]; + term7 = rr5*prc5[0] - term2*xr; + tixy = ci*term3 - psr5*dix*yr + diy*term4 + dir*term5 + + 2.0*psr5*qixy - 2.0*psr7*yr*qix + 2.0*qiy*term7 + qir*term6; + tkxy = ck*term3 + psr5*dkx*yr - dky*term4 - dkr*term5 + + 2.0*psr5*qkxy - 2.0*psr7*yr*qkx + 2.0*qky*term7 + qkr*term6; + term3 = term1*xr*zr - rr3*zr*prc3[0]; + term5 = term2*xr*zr - rr5*zr*prc5[0]; + term6 = (bn[4]-psc7*rr9)*xr*zr - rr7*zr*prc7[0]; + tixz = ci*term3 - psr5*dix*zr + diz*term4 + dir*term5 + + 2.0*psr5*qixz - 2.0*psr7*zr*qix + 2.0*qiz*term7 + qir*term6; + tkxz = ck*term3 + psr5*dkx*zr - dkz*term4 - dkr*term5 + + 2.0*psr5*qkxz - 2.0*psr7*zr*qkx + 2.0*qkz*term7 + qkr*term6; + term3 = term1*yr*zr - rr3*zr*prc3[1]; + term4 = rr3*prc3[1] - term1*yr; + term5 = term2*yr*zr - rr5*zr*prc5[1]; + term6 = (bn[4]-psc7*rr9)*yr*zr - rr7*zr*prc7[1]; + term7 = rr5*prc5[1] - term2*yr; + tiyz = ci*term3 - psr5*diy*zr + diz*term4 + dir*term5 + + 2.0*psr5*qiyz - 2.0*psr7*zr*qiy + 2.0*qiz*term7 + qir*term6; + tkyz = ck*term3 + psr5*dky*zr - dkz*term4 - dkr*term5 + + 2.0*psr5*qkyz - 2.0*psr7*zr*qky + 2.0*qkz*term7 + qkr*term6; + depx = tixx*ukx + tixy*uky + tixz*ukz - tkxx*uix - tkxy*uiy - tkxz*uiz; + depy = tixy*ukx + tiyy*uky + tiyz*ukz - tkxy*uix - tkyy*uiy - tkyz*uiz; + depz = tixz*ukx + tiyz*uky + tizz*ukz - tkxz*uix - tkyz*uiy - tkzz*uiz; + frcx = frcx + depx; + frcy = frcy + depy; + frcz = frcz + depz; + + // get the field gradient for direct polarization force + + } else if (hippo) { + term1i = rr3i - rr5i*xr*xr; + term1core = rr3core - rr5core*xr*xr; + term2i = 2.0*rr5i*xr ; + term3i = rr7i*xr*xr - rr5i; + term4i = 2.0*rr5i; + term5i = 5.0*rr7i*xr; + term6i = rr9i*xr*xr; + term1k = rr3k - rr5k*xr*xr; + term2k = 2.0*rr5k*xr; + term3k = rr7k*xr*xr - rr5k; + term4k = 2.0*rr5k; + term5k = 5.0*rr7k*xr; + term6k = rr9k*xr*xr; + tixx = vali*term1i + corei*term1core + dix*term2i - dir*term3i - + qixx*term4i + qix*term5i - qir*term6i + (qiy*yr+qiz*zr)*rr7i; + tkxx = valk*term1k + corek*term1core - dkx*term2k + dkr*term3k - + qkxx*term4k + qkx*term5k - qkr*term6k + (qky*yr+qkz*zr)*rr7k; + term1i = rr3i - rr5i*yr*yr; + term1core = rr3core - rr5core*yr*yr; + term2i = 2.0*rr5i*yr; + term3i = rr7i*yr*yr - rr5i; + term4i = 2.0*rr5i; + term5i = 5.0*rr7i*yr; + term6i = rr9i*yr*yr; + term1k = rr3k - rr5k*yr*yr; + term2k = 2.0*rr5k*yr; + term3k = rr7k*yr*yr - rr5k; + term4k = 2.0*rr5k; + term5k = 5.0*rr7k*yr; + term6k = rr9k*yr*yr; + tiyy = vali*term1i + corei*term1core + diy*term2i - dir*term3i - + qiyy*term4i + qiy*term5i - qir*term6i + (qix*xr+qiz*zr)*rr7i; + tkyy = valk*term1k + corek*term1core - dky*term2k + dkr*term3k - + qkyy*term4k + qky*term5k - qkr*term6k + (qkx*xr+qkz*zr)*rr7k; + term1i = rr3i - rr5i*zr*zr; + term1core = rr3core - rr5core*zr*zr; + term2i = 2.0*rr5i*zr; + term3i = rr7i*zr*zr - rr5i; + term4i = 2.0*rr5i; + term5i = 5.0*rr7i*zr; + term6i = rr9i*zr*zr; + term1k = rr3k - rr5k*zr*zr; + term2k = 2.0*rr5k*zr; + term3k = rr7k*zr*zr - rr5k; + term4k = 2.0*rr5k; + term5k = 5.0*rr7k*zr; + term6k = rr9k*zr*zr; + tizz = vali*term1i + corei*term1core + diz*term2i - dir*term3i - + qizz*term4i + qiz*term5i - qir*term6i + (qix*xr+qiy*yr)*rr7i; + tkzz = valk*term1k + corek*term1core - dkz*term2k + dkr*term3k - + qkzz*term4k + qkz*term5k - qkr*term6k + (qkx*xr+qky*yr)*rr7k; + term2i = rr5i*xr ; + term1i = yr * term2i; + term1core = rr5core*xr*yr; + term3i = rr5i*yr; + term4i = yr * (rr7i*xr); + term5i = 2.0*rr5i; + term6i = 2.0*rr7i*xr; + term7i = 2.0*rr7i*yr; + term8i = yr*rr9i*xr; + term2k = rr5k*xr; + term1k = yr * term2k; + term3k = rr5k*yr; + term4k = yr * (rr7k*xr); + term5k = 2.0*rr5k; + term6k = 2.0*rr7k*xr; + term7k = 2.0*rr7k*yr; + term8k = yr*rr9k*xr; + tixy = -vali*term1i - corei*term1core + diy*term2i + dix*term3i - + dir*term4i - qixy*term5i + qiy*term6i + qix*term7i - qir*term8i; + tkxy = -valk*term1k - corek*term1core - dky*term2k - dkx*term3k + + dkr*term4k - qkxy*term5k + qky*term6k + qkx*term7k - qkr*term8k; + term2i = rr5i*xr; + term1i = zr * term2i; + term1core = rr5core*xr*zr; + term3i = rr5i*zr; + term4i = zr * (rr7i*xr); + term5i = 2.0*rr5i; + term6i = 2.0*rr7i*xr; + term7i = 2.0*rr7i*zr; + term8i = zr*rr9i*xr; + term2k = rr5k*xr; + term1k = zr * term2k; + term3k = rr5k*zr; + term4k = zr * (rr7k*xr); + term5k = 2.0*rr5k; + term6k = 2.0*rr7k*xr; + term7k = 2.0*rr7k*zr; + term8k = zr*rr9k*xr; + tixz = -vali*term1i - corei*term1core + diz*term2i + dix*term3i - + dir*term4i - qixz*term5i + qiz*term6i + qix*term7i - qir*term8i; + tkxz = -valk*term1k - corek*term1core - dkz*term2k - dkx*term3k + + dkr*term4k - qkxz*term5k + qkz*term6k + qkx*term7k - qkr*term8k; + term2i = rr5i*yr; + term1i = zr * term2i; + term1core = rr5core*yr*zr; + term3i = rr5i*zr; + term4i = zr * (rr7i*yr); + term5i = 2.0*rr5i; + term6i = 2.0*rr7i*yr; + term7i = 2.0*rr7i*zr; + term8i = zr*rr9i*yr; + term2k = rr5k*yr; + term1k = zr * term2k; + term3k = rr5k*zr; + term4k = zr * (rr7k*yr); + term5k = 2.0*rr5k; + term6k = 2.0*rr7k*yr; + term7k = 2.0*rr7k*zr; + term8k = zr*rr9k*yr; + tiyz = -vali*term1i - corei*term1core + diz*term2i + diy*term3i - + dir*term4i - qiyz*term5i + qiz*term6i + qiy*term7i - qir*term8i; + tkyz = -valk*term1k - corek*term1core - dkz*term2k - dky*term3k + + dkr*term4k - qkyz*term5k + qkz*term6k + qky*term7k - qkr*term8k; + depx = tixx*ukx + tixy*uky + tixz*ukz - tkxx*uix - tkxy*uiy - tkxz*uiz; + depy = tixy*ukx + tiyy*uky + tiyz*ukz - tkxy*uix - tkyy*uiy - tkyz*uiz; + depz = tixz*ukx + tiyz*uky + tizz*ukz - tkxz*uix - tkyz*uiy - tkzz*uiz; + frcx = -2.0 * depx; + frcy = -2.0 * depy; + frcz = -2.0 * depz; + } + + // get the dtau/dr terms used for mutual polarization force + + if (poltyp == MUTUAL && amoeba) { + term1 = bn[2] - usc3*rr5; + term2 = bn[3] - usc5*rr7; + term3 = usr5 + term1; + term4 = rr3 * factor_uscale; + term5 = -xr*term3 + rc3[0]*term4; + term6 = -usr5 + xr*xr*term2 - rr5*xr*urc5[0]; + tixx = uix*term5 + uir*term6; + tkxx = ukx*term5 + ukr*term6; + term5 = -yr*term3 + rc3[1]*term4; + term6 = -usr5 + yr*yr*term2 - rr5*yr*urc5[1]; + tiyy = uiy*term5 + uir*term6; + tkyy = uky*term5 + ukr*term6; + term5 = -zr*term3 + rc3[2]*term4; + term6 = -usr5 + zr*zr*term2 - rr5*zr*urc5[2]; + tizz = uiz*term5 + uir*term6; + tkzz = ukz*term5 + ukr*term6; + term4 = -usr5 * yr; + term5 = -xr*term1 + rr3*urc3[0]; + term6 = xr*yr*term2 - rr5*yr*urc5[0]; + tixy = uix*term4 + uiy*term5 + uir*term6; + tkxy = ukx*term4 + uky*term5 + ukr*term6; + term4 = -usr5 * zr; + term6 = xr*zr*term2 - rr5*zr*urc5[0]; + tixz = uix*term4 + uiz*term5 + uir*term6; + tkxz = ukx*term4 + ukz*term5 + ukr*term6; + term5 = -yr*term1 + rr3*urc3[1]; + term6 = yr*zr*term2 - rr5*zr*urc5[1]; + tiyz = uiy*term4 + uiz*term5 + uir*term6; + tkyz = uky*term4 + ukz*term5 + ukr*term6; + depx = tixx*ukxp + tixy*ukyp + tixz*ukzp + + tkxx*uixp + tkxy*uiyp + tkxz*uizp; + depy = tixy*ukxp + tiyy*ukyp + tiyz*ukzp + + tkxy*uixp + tkyy*uiyp + tkyz*uizp; + depz = tixz*ukxp + tiyz*ukyp + tizz*ukzp + + tkxz*uixp + tkyz*uiyp + tkzz*uizp; + frcx = frcx + depx; + frcy = frcy + depy; + frcz = frcz + depz; + + // get the dtau/dr terms used for mutual polarization force + + } else if (poltyp == MUTUAL && hippo) { + term1 = 2.0 * rr5ik; + term2 = term1*xr; + term3 = rr5ik - rr7ik*xr*xr; + tixx = uix*term2 + uir*term3; + tkxx = ukx*term2 + ukr*term3; + term2 = term1*yr; + term3 = rr5ik - rr7ik*yr*yr; + tiyy = uiy*term2 + uir*term3; + tkyy = uky*term2 + ukr*term3; + term2 = term1*zr; + term3 = rr5ik - rr7ik*zr*zr; + tizz = uiz*term2 + uir*term3; + tkzz = ukz*term2 + ukr*term3; + term1 = rr5ik*yr; + term2 = rr5ik*xr; + term3 = yr * (rr7ik*xr); + tixy = uix*term1 + uiy*term2 - uir*term3; + tkxy = ukx*term1 + uky*term2 - ukr*term3; + term1 = rr5ik * zr; + term3 = zr * (rr7ik*xr); + tixz = uix*term1 + uiz*term2 - uir*term3; + tkxz = ukx*term1 + ukz*term2 - ukr*term3; + term2 = rr5ik*yr; + term3 = zr * (rr7ik*yr); + tiyz = uiy*term1 + uiz*term2 - uir*term3; + tkyz = uky*term1 + ukz*term2 - ukr*term3; + depx = tixx*ukxp + tixy*ukyp + tixz*ukzp + tkxx*uixp + tkxy*uiyp + tkxz*uizp; + depy = tixy*ukxp + tiyy*ukyp + tiyz*ukzp + tkxy*uixp + tkyy*uiyp + tkyz*uizp; + depz = tixz*ukxp + tiyz*ukyp + tizz*ukzp + tkxz*uixp + tkyz*uiyp + tkzz*uizp; + frcx = frcx - depx; + frcy = frcy - depy; + frcz = frcz - depz; + + // get the dtau/dr terms used for OPT polarization force + + } else if (poltyp == OPT && amoeba) { + for (k = 0; k < optorder; k++) { + uirm = uopt[i][k][0]*xr + uopt[i][k][1]*yr + uopt[i][k][2]*zr; + for (m = 0; m < optorder-k; m++) { + ukrm = uopt[j][m][0]*xr + uopt[j][m][1]*yr + uopt[j][m][2]*zr; + term1 = bn[2] - usc3*rr5; + term2 = bn[3] - usc5*rr7; + term3 = usr5 + term1; + term4 = rr3 * factor_uscale; + term5 = -xr*term3 + rc3[0]*term4; + term6 = -usr5 + xr*xr*term2 - rr5*xr*urc5[0]; + tixx = uopt[i][k][0]*term5 + uirm*term6; + tkxx = uopt[j][m][0]*term5 + ukrm*term6; + term5 = -yr*term3 + rc3[1]*term4; + term6 = -usr5 + yr*yr*term2 - rr5*yr*urc5[1]; + tiyy = uopt[i][k][1]*term5 + uirm*term6; + tkyy = uopt[j][m][1]*term5 + ukrm*term6; + term5 = -zr*term3 + rc3[2]*term4; + term6 = -usr5 + zr*zr*term2 - rr5*zr*urc5[2]; + tizz = uopt[i][k][2]*term5 + uirm*term6; + tkzz = uopt[j][m][2]*term5 + ukrm*term6; + term4 = -usr5 * yr; + term5 = -xr*term1 + rr3*urc3[0]; + term6 = xr*yr*term2 - rr5*yr*urc5[0]; + tixy = uopt[i][k][0]*term4 + uopt[i][k][1]*term5 + uirm*term6; + tkxy = uopt[j][m][0]*term4 + uopt[j][m][1]*term5 + ukrm*term6; + term4 = -usr5 * zr; + term6 = xr*zr*term2 - rr5*zr*urc5[0]; + tixz = uopt[i][k][0]*term4 + uopt[i][k][2]*term5 + uirm*term6; + tkxz = uopt[j][m][0]*term4 + uopt[j][m][2]*term5 + ukrm*term6; + term5 = -yr*term1 + rr3*urc3[1]; + term6 = yr*zr*term2 - rr5*zr*urc5[1]; + tiyz = uopt[i][k][1]*term4 + uopt[i][k][2]*term5 + uirm*term6; + tkyz = uopt[j][m][1]*term4 + uopt[j][m][2]*term5 + ukrm*term6; + depx = tixx*uoptp[j][m][0] + tkxx*uoptp[i][k][0] + tixy*uoptp[j][m][1] + + tkxy*uoptp[i][k][1] + tixz*uoptp[j][m][2] + tkxz*uoptp[i][k][2]; + depy = tixy*uoptp[j][m][0] + tkxy*uoptp[i][k][0] + tiyy*uoptp[j][m][1] + + tkyy*uoptp[i][k][1] + tiyz*uoptp[j][m][2] + tkyz*uoptp[i][k][2]; + depz = tixz*uoptp[j][m][0] + tkxz*uoptp[i][k][0] + tiyz*uoptp[j][m][1] + + tkyz*uoptp[i][k][1] + tizz*uoptp[j][m][2] + tkzz*uoptp[i][k][2]; + frcx += copm[k+m+1]*depx; + frcy += copm[k+m+1]*depy; + frcz += copm[k+m+1]*depz; + } + } + + // get the dtau/dr terms used for OPT polarization force + + } else if (poltyp == OPT && hippo) { + for (k = 0; k < optorder; k++) { + uirm = uopt[i][k][0]*xr + uopt[i][k][1]*yr + uopt[i][k][2]*zr; + for (m = 0; m < optorder-k; m++) { + ukrm = uopt[j][m][0]*xr + uopt[j][m][1]*yr + uopt[j][m][2]*zr; + term1 = 2.0 * rr5ik; + term2 = term1*xr; + term3 = rr5ik - rr7ik*xr*xr; + tixx = uopt[i][k][0]*term2 + uirm*term3; + tkxx = uopt[j][m][0]*term2 + ukrm*term3; + term2 = term1*yr; + term3 = rr5ik - rr7ik*yr*yr; + tiyy = uopt[i][k][1]*term2 + uirm*term3; + tkyy = uopt[j][m][1]*term2 + ukrm*term3; + term2 = term1*zr; + term3 = rr5ik - rr7ik*zr*zr; + tizz = uopt[i][k][2]*term2 + uirm*term3; + tkzz = uopt[j][m][2]*term2 + ukrm*term3; + term1 = rr5ik*yr; + term2 = rr5ik*xr; + term3 = yr * (rr7ik*xr); + tixy = uopt[i][k][0]*term1 + uopt[i][k][1]*term2 - uirm*term3; + tkxy = uopt[j][m][0]*term1 + uopt[j][m][1]*term2 - ukrm*term3; + term1 = rr5ik * zr; + term3 = zr * (rr7ik*xr); + tixz = uopt[i][k][0]*term1 + uopt[i][k][2]*term2 - uirm*term3; + tkxz = uopt[j][m][0]*term1 + uopt[j][m][2]*term2 - ukrm*term3; + term2 = rr5ik*yr; + term3 = zr * (rr7ik*yr); + tiyz = uopt[i][k][1]*term1 + uopt[i][k][2]*term2 - uirm*term3; + tkyz = uopt[j][m][1]*term1 + uopt[j][m][2]*term2 - ukrm*term3; + depx = tixx*uoptp[j][m][0] + tkxx*uoptp[i][k][0] + tixy*uoptp[j][m][1] + + tkxy*uoptp[i][k][1] + tixz*uoptp[j][m][2] + tkxz*uoptp[i][k][2]; + depy = tixy*uoptp[j][m][0] + tkxy*uoptp[i][k][0] + tiyy*uoptp[j][m][1] + + tkyy*uoptp[i][k][1] + tiyz*uoptp[j][m][2] + tkyz*uoptp[i][k][2]; + depz = tixz*uoptp[j][m][0] + tkxz*uoptp[i][k][0] + tiyz*uoptp[j][m][1] + + tkyz*uoptp[i][k][1] + tizz*uoptp[j][m][2] + tkzz*uoptp[i][k][2]; + frcx -= copm[k+m+1]*depx; + frcy -= copm[k+m+1]*depy; + frcz -= copm[k+m+1]*depz; + } + } + + // get the dtau/dr terms used for TCG polarization force + + } else if (poltyp == TCG) { + /* + for (m = 0; m < tcgnab; m++) { + ukx = ubd[m][j][0]; + uky = ubd[m][j][1]; + ukz = ubd[m][j][2]; + ukxp = ubp[m][j][0]; + ukyp = ubp[m][j][1]; + ukzp = ubp[m][j][2]; + uirt = uax[m]*xr + uay[m]*yr + uaz[m]*zr; + ukrt = ukx*xr + uky*yr + ukz*zr; + term1 = bn[2] - usc3*rr5; + term2 = bn[3] - usc5*rr7; + term3 = usr5 + term1; + term4 = rr3 * factor_uscale; + term5 = -xr*term3 + rc3[0]*term4; + term6 = -usr5 + xr*xr*term2 - rr5*xr*urc5[0]; + tixx = uax[m]*term5 + uirt*term6; + tkxx = ukx*term5 + ukrt*term6; + term5 = -yr*term3 + rc3[1]*term4; + term6 = -usr5 + yr*yr*term2 - rr5*yr*urc5[1]; + tiyy = uay[m]*term5 + uirt*term6; + tkyy = uky*term5 + ukrt*term6; + term5 = -zr*term3 + rc3[2]*term4; + term6 = -usr5 + zr*zr*term2 - rr5*zr*urc5[2]; + tizz = uaz[m]*term5 + uirt*term6; + tkzz = ukz*term5 + ukrt*term6; + term4 = -usr5 * yr; + term5 = -xr*term1 + rr3*urc3[0]; + term6 = xr*yr*term2 - rr5*yr*urc5[0]; + tixy = uax[m]*term4 + uay[m]*term5 + uirt*term6; + tkxy = ukx*term4 + uky*term5 + ukrt*term6; + term4 = -usr5 * zr; + term6 = xr*zr*term2 - rr5*zr*urc5[0]; + tixz = uax[m]*term4 + uaz[m]*term5 + uirt*term6; + tkxz = ukx*term4 + ukz*term5 + ukrt*term6; + term5 = -yr*term1 + rr3*urc3[1]; + term6 = yr*zr*term2 - rr5*zr*urc5[1]; + tiyz = uay[m]*term4 + uaz[m]*term5 + uirt*term6; + tkyz = uky*term4 + ukz*term5 + ukrt*term6; + depx = tixx*ukxp + tixy*ukyp + tixz*ukzp + + tkxx*uaxp[m] + tkxy*uayp[m] + + tkxz*uazp[m]; + depy = tixy*ukxp + tiyy*ukyp + tiyz*ukzp + + tkxy*uaxp[m] + tkyy*uayp[m] + + tkyz*uazp[m]; + depz = tixz*ukxp + tiyz*ukyp + tizz*ukzp + + tkxz*uaxp[m] + tkyz*uayp[m] + + tkzz*uazp[m]; + frcx += depx; + frcy += depy; + frcz += depz; + + ukx = uad[m][j][0]; + uky = uad[m][j][1]; + ukz = uad[m][j][2]; + ukxp = uap[m][j][0]; + ukyp = uap[m][j][1]; + ukzp = uap[m][j][2]; + uirt = ubx[m]*xr + uby[m]*yr + ubz[m]*zr; + ukrt = ukx*xr + uky*yr + ukz*zr; + term1 = bn[2] - usc3*rr5; + term2 = bn[3] - usc5*rr7; + term3 = usr5 + term1; + term4 = rr3 * factor_uscale; + term5 = -xr*term3 + rc3[0]*term4; + term6 = -usr5 + xr*xr*term2 - rr5*xr*urc5[0]; + tixx = ubx[m]*term5 + uirt*term6; + tkxx = ukx*term5 + ukrt*term6; + term5 = -yr*term3 + rc3[1]*term4; + term6 = -usr5 + yr*yr*term2 - rr5*yr*urc5[1]; + tiyy = uby[m]*term5 + uirt*term6; + tkyy = uky*term5 + ukrt*term6; + term5 = -zr*term3 + rc3[2]*term4; + term6 = -usr5 + zr*zr*term2 - rr5*zr*urc5[2]; + tizz = ubz[m]*term5 + uirt*term6; + tkzz = ukz*term5 + ukrt*term6; + term4 = -usr5 * yr; + term5 = -xr*term1 + rr3*urc3[0]; + term6 = xr*yr*term2 - rr5*yr*urc5[0]; + tixy = ubx[m]*term4 + uby[m]*term5 + uirt*term6; + tkxy = ukx*term4 + uky*term5 + ukrt*term6; + term4 = -usr5 * zr; + term6 = xr*zr*term2 - rr5*zr*urc5[0]; + tixz = ubx[m]*term4 + ubz[m]*term5 + uirt*term6; + tkxz = ukx*term4 + ukz*term5 + ukrt*term6; + term5 = -yr*term1 + rr3*urc3[1]; + term6 = yr*zr*term2 - rr5*zr*urc5[1]; + tiyz = uby[m]*term4 + ubz[m]*term5 + uirt*term6; + tkyz = uky*term4 + ukz*term5 + ukrt*term6; + depx = tixx*ukxp + tixy*ukyp + tixz*ukzp + + tkxx*ubxp[m] + tkxy*ubyp[m] + + tkxz*ubzp[m]; + depy = tixy*ukxp + tiyy*ukyp + tiyz*ukzp + + tkxy*ubxp[m] + tkyy*ubyp[m] + + tkyz*ubzp[m]; + depz = tixz*ukxp + tiyz*ukyp + tizz*ukzp + + tkxz*ubxp[m] + tkyz*ubyp[m] + + tkzz*ubzp[m]; + frcx += depx; + frcy += depy; + frcz += depz; + } + */ + } + + // increment force-based gradient on the interaction sites + + fpolar[i][0] -= frcx; + fpolar[i][1] -= frcy; + fpolar[i][2] -= frcz; + fpolar[j][0] += frcx; + fpolar[j][1] += frcy; + fpolar[j][2] += frcz; + + // increment the virial due to pairwise Cartesian forces + + vxx = xr * frcx; + vxy = 0.5 * (yr*frcx+xr*frcy); + vxz = 0.5 * (zr*frcx+xr*frcz); + vyy = yr * frcy; + vyz = 0.5 * (zr*frcy+yr*frcz); + vzz = zr * frcz; + + virpolar[0] += vxx; + virpolar[1] += vyy; + virpolar[2] += vzz; + virpolar[3] += vxy; + virpolar[4] += vxz; + virpolar[5] += vyz; + + // energy = e + // virial = 6-vec vir + // NOTE: add tally function + + if (evflag) { + } + } + } + + // reverse comm to sum ufld,dufld from ghost atoms to owned atoms + + crstyle = UFLD; + comm->reverse_comm_pair(this); + + // torque is induced field and gradient cross permanent moments + + for (i = 0; i < nlocal; i++) { + dix = rpole[i][1]; + diy = rpole[i][2]; + diz = rpole[i][3]; + qixx = rpole[i][4]; + qixy = rpole[i][5]; + qixz = rpole[i][6]; + qiyy = rpole[i][8]; + qiyz = rpole[i][9]; + qizz = rpole[i][12]; + tep[0] = diz*ufld[i][1] - diy*ufld[i][2] + + qixz*dufld[i][1] - qixy*dufld[i][3] + + 2.0*qiyz*(dufld[i][2]-dufld[i][5]) + (qizz-qiyy)*dufld[i][4]; + tep[1] = dix*ufld[i][2] - diz*ufld[i][0] - + qiyz*dufld[i][1] + qixy*dufld[i][4] + + 2.0*qixz*(dufld[i][5]-dufld[i][0]) + (qixx-qizz)*dufld[i][3]; + tep[2] = diy*ufld[i][0] - dix*ufld[i][1] + + qiyz*dufld[i][3] - qixz*dufld[i][4] + + 2.0*qixy*(dufld[i][0]-dufld[i][2]) + (qiyy-qixx)*dufld[i][1]; + + torque2force(i,tep,fix,fiy,fiz,fpolar); + + iz = zaxis2local[i]; + ix = xaxis2local[i]; + iy = yaxis2local[i]; + + xiz = x[iz][0] - x[i][0]; + yiz = x[iz][1] - x[i][1]; + ziz = x[iz][2] - x[i][2]; + xix = x[ix][0] - x[i][0]; + yix = x[ix][1] - x[i][1]; + zix = x[ix][2] - x[i][2]; + xiy = x[iy][0] - x[i][0]; + yiy = x[iy][1] - x[i][1]; + ziy = x[iy][2] - x[i][2]; + + vxx = xix*fix[0] + xiy*fiy[0] + xiz*fiz[0]; + vyy = yix*fix[1] + yiy*fiy[1] + yiz*fiz[1]; + vzz = zix*fix[2] + ziy*fiy[2] + ziz*fiz[2]; + vxy = 0.5 * (yix*fix[0] + yiy*fiy[0] + yiz*fiz[0] + + xix*fix[1] + xiy*fiy[1] + xiz*fiz[1]); + vxz = 0.5 * (zix*fix[0] + ziy*fiy[0] + ziz*fiz[0] + + xix*fix[2] + xiy*fiy[2] + xiz*fiz[2]); + vyz = 0.5 * (zix*fix[1] + ziy*fiy[1] + ziz*fiz[1] + + yix*fix[2] + yiy*fiy[2] + yiz*fiz[2]); + + virpolar[0] += vxx; + virpolar[1] += vyy; + virpolar[2] += vzz; + virpolar[3] += vxy; + virpolar[4] += vxz; + virpolar[5] += vyz; + } +} + +/* ---------------------------------------------------------------------- + polar_kspace = KSpace portion of induced dipole polarization + adapted from Tinker eprecip1() routine + ------------------------------------------------------------------------- */ + +void PairAmoeba::polar_kspace() +{ + int i,j,k,m,n; + int nhalf1,nhalf2,nhalf3; + int nxlo,nxhi,nylo,nyhi,nzlo,nzhi; + int j1,j2,j3; + int k1,k2,k3; + int ix,iy,iz; + double eterm,felec; + double r1,r2,r3; + double h1,h2,h3; + double f1,f2,f3; + double xix,yix,zix; + double xiy,yiy,ziy; + double xiz,yiz,ziz; + double vxx,vyy,vzz; + double vxy,vxz,vyz; + double volterm,denom; + double hsq,expterm; + double term,pterm; + double vterm,struc2; + double tep[3]; + double fix[3],fiy[3],fiz[3]; + double cphid[4],cphip[4]; + double a[3][3]; // indices not flipped vs Fortran + + double **fuind,**fuinp,**fphid,**fphip; + double **fphidp,**cphidp; + + // indices into the electrostatic field array + // decremented by 1 versus Fortran + + int deriv1[10] = {1, 4, 7, 8, 10, 15, 17, 13, 14, 19}; + int deriv2[10] = {2, 7, 5, 9, 13, 11, 18, 15, 19, 16}; + int deriv3[10] = {3, 8, 9, 6, 14, 16, 12, 19, 17, 18}; + + // return if the Ewald coefficient is zero + + if (aewald < 1.0e-6) return; + + // owned atoms + + double **x = atom->x; + int nlocal = atom->nlocal; + + double volbox = domain->prd[0] * domain->prd[1] * domain->prd[2]; + pterm = pow((MY_PI/aewald),2.0); + volterm = MY_PI * volbox; + + // initialize variables required for the scalar summation + + felec = electric / am_dielectric; + + // dynamic allocation of local arrays + // NOTE: just do this one time? + // NOTE: overlap with induce + + memory->create(fuind,nlocal,3,"polar:fuind"); + memory->create(fuinp,nlocal,3,"polar:fuinp"); + memory->create(fphid,nlocal,10,"polar:fphid"); + memory->create(fphip,nlocal,10,"polar:fphip"); + memory->create(fphidp,nlocal,20,"polar:fphidp"); + memory->create(cphidp,nlocal,10,"polar:cphidp"); + + // remove scalar sum virial from prior multipole FFT + // can only do this if multipoles were computed with same aeewald = apewald + // else need to re-compute it via new long-range solve + + nfft1 = p_kspace->nx; + nfft2 = p_kspace->ny; + nfft3 = p_kspace->nz; + bsorder = p_kspace->order; + + nhalf1 = (nfft1+1) / 2; + nhalf2 = (nfft2+1) / 2; + nhalf3 = (nfft3+1) / 2; + + nxlo = p_kspace->nxlo_fft; + nxhi = p_kspace->nxhi_fft; + nylo = p_kspace->nylo_fft; + nyhi = p_kspace->nyhi_fft; + nzlo = p_kspace->nzlo_fft; + nzhi = p_kspace->nzhi_fft; + + // use previous results or compute new qfac and convolution + + if (aewald == aeewald) { + vxx = -vmsave[0]; + vyy = -vmsave[1]; + vzz = -vmsave[2]; + vxy = -vmsave[3]; + vxz = -vmsave[4]; + vyz = -vmsave[5]; + + } else { + + // setup stencil size and B-spline coefficients + + moduli(); + bspline_fill(); + + // convert Cartesian multipoles to fractional coordinates + + cmp_to_fmp(cmp,fmp); + + // gridpre = my portion of 3d grid in brick decomp w/ ghost values + + double ***gridpre = (double ***) p_kspace->zero(); + + // map atoms to grid + + grid_mpole(fmp,gridpre); + + // pre-convolution operations including forward FFT + // gridfft = my portion of complex 3d grid in FFT decomp as 1d vector + + double *gridfft = p_kspace->pre_convolution(); + + // --------------------- + // convolution operation + // --------------------- + + // zero virial accumulation variables + + vxx = vyy = vzz = vxy = vxz = vyz = 0.0; + + // perform convolution on K-space points I own + + m = n = 0; + for (k = nzlo; k <= nzhi; k++) { + for (j = nylo; j <= nyhi; j++) { + for (i = nxlo; i <= nxhi; i++) { + r1 = (i >= nhalf1) ? i-nfft1 : i; + r2 = (j >= nhalf2) ? j-nfft2 : j; + r3 = (k >= nhalf3) ? k-nfft3 : k; + h1 = recip[0][0]*r1 + recip[0][1]*r2 + recip[0][2]*r3; // matvec + h2 = recip[1][0]*r1 + recip[1][1]*r2 + recip[1][2]*r3; + h3 = recip[2][0]*r1 + recip[2][1]*r2 + recip[2][2]*r3; + hsq = h1*h1 + h2*h2 + h3*h3; + term = -pterm * hsq; + expterm = 0.0; + if (term > -50.0 && hsq != 0.0) { + denom = volterm*hsq*bsmod1[i]*bsmod2[j]*bsmod3[k]; + if (hsq) expterm = exp(term) / denom; + struc2 = gridfft[n]*gridfft[n] + gridfft[n+1]*gridfft[n+1]; + eterm = 0.5 * felec * expterm * struc2; + vterm = (2.0/hsq) * (1.0-term) * eterm; + vxx -= h1*h1*vterm - eterm; + vyy -= h2*h2*vterm - eterm; + vzz -= h3*h3*vterm - eterm; + vxy -= h1*h2*vterm; + vxz -= h1*h3*vterm; + vyz -= h2*h3*vterm; + } + + expterm = qfac[m++]; + gridfft[n] *= expterm; + gridfft[n+1] *= expterm; + n += 2; + } + } + } + + // post-convolution operations including backward FFT + // gridppost = my portion of 3d grid in brick decomp w/ ghost values + + double ***gridpost = (double ***) p_kspace->post_convolution(); + + // get potential + + fphi_mpole(gridpost,fphi); + + for (i = 0; i < nlocal; i++) { + for (k = 0; k < 20; k++) + fphi[i][k] *= felec; + } + + // convert field from fractional to Cartesian + + fphi_to_cphi(fphi,cphi); + } + + // convert Cartesian induced dipoles to fractional coordinates + + for (i = 0; i < 3; i++) { + a[0][i] = nfft1 * recip[0][i]; + a[1][i] = nfft2 * recip[1][i]; + a[2][i] = nfft3 * recip[2][i]; + } + + for (i = 0; i < nlocal; i++) { + for (j = 0; j < 3; j++) { + fuind[i][j] = a[j][0]*uind[i][0] + a[j][1]*uind[i][1] + a[j][2]*uind[i][2]; + fuinp[i][j] = a[j][0]*uinp[i][0] + a[j][1]*uinp[i][1] + a[j][2]*uinp[i][2]; + } + } + + //PRINT fuind + + // gridpre2 = my portion of 4d grid in brick decomp w/ ghost values + + double ****gridpre2 = (double ****) pc_kspace->zero(); + + // map 2 values to grid + + grid_uind(fuind,fuinp,gridpre2); + + // pre-convolution operations including forward FFT + // gridfft = my portion of complex 3d grid in FFT decomposition + + double *gridfft = pc_kspace->pre_convolution(); + + // --------------------- + // convolution operation + // --------------------- + + // use qfac values from above or from induce() + + m = n = 0; + for (k = nzlo; k <= nzhi; k++) { + for (j = nylo; j <= nyhi; j++) { + for (i = nxlo; i <= nxhi; i++) { + term = qfac[m++]; + gridfft[n] *= term; + gridfft[n+1] *= term; + n += 2; + } + } + } + + // post-convolution operations including backward FFT + // gridppost = my portion of 4d grid in brick decomp w/ ghost values + + double ****gridpost = (double ****) pc_kspace->post_convolution(); + + // get potential + + fphi_uind(gridpost,fphid,fphip,fphidp); + + for (i = 0; i < nlocal; i++) { + for (j = 1; j < 10; j++) { + fphid[i][j] = felec * fphid[i][j]; + fphip[i][j] = felec * fphip[i][j]; + } + for (j = 0; j < 20; j++) + fphidp[i][j] = felec * fphidp[i][j]; + } + + // increment the dipole polarization gradient contributions + + for (i = 0; i < nlocal; i++) { + f1 = 0.0; + f2 = 0.0; + f3 = 0.0; + for (k = 0; k < 3; k++) { + j1 = deriv1[k+1]; + j2 = deriv2[k+1]; + j3 = deriv3[k+1]; + f1 += (fuind[i][k]+fuinp[i][k])*fphi[i][j1]; + f2 += (fuind[i][k]+fuinp[i][k])*fphi[i][j2]; + f3 += (fuind[i][k]+fuinp[i][k])*fphi[i][j3]; + if (poltyp == MUTUAL) { + f1 += fuind[i][k]*fphip[i][j1] + fuinp[i][k]*fphid[i][j1]; + f2 += fuind[i][k]*fphip[i][j2] + fuinp[i][k]*fphid[i][j2]; + f3 += fuind[i][k]*fphip[i][j3] + fuinp[i][k]*fphid[i][j3]; + } + } + for (k = 0; k < 10; k++) { + f1 += fmp[i][k]*fphidp[i][deriv1[k]]; + f2 += fmp[i][k]*fphidp[i][deriv2[k]]; + f3 += fmp[i][k]*fphidp[i][deriv3[k]]; + } + f1 *= 0.5 * nfft1; + f2 *= 0.5 * nfft2; + f3 *= 0.5 * nfft3; + h1 = recip[0][0]*f1 + recip[0][1]*f2 + recip[0][2]*f3; + h2 = recip[1][0]*f1 + recip[1][1]*f2 + recip[1][2]*f3; + h3 = recip[2][0]*f1 + recip[2][1]*f2 + recip[2][2]*f3; + fpolar[i][0] += h1; + fpolar[i][1] += h2; + fpolar[i][2] += h3; + } + + // set the potential to be the induced dipole average + + for (i = 0; i < nlocal; i++) { + for (j = 0; j < 10; j++) + fphidp[i][j] *= 0.5; + } + + fphi_to_cphi(fphidp,cphidp); + + // get the fractional to Cartesian transformation matrix + + frac_to_cart(); + + // increment the dipole polarization virial contributions + + for (i = 0; i < nlocal; i++) { + for (j = 1; j < 4; j++) { + cphid[j] = 0.0; + cphip[j] = 0.0; + for (k = 1; k < 4; k++) { + cphid[j] += ftc[j][k]*fphid[i][k]; + cphip[j] += ftc[j][k]*fphip[i][k]; + } + } + + vxx -= cmp[i][1]*cphidp[i][1] + + 0.5*((uind[i][0]+uinp[i][0])*cphi[i][1]); + vyy -= cmp[i][2]*cphidp[i][2] + + 0.5*((uind[i][1]+uinp[i][1])*cphi[i][2]); + vzz -= cmp[i][3]*cphidp[i][3] + + 0.5*((uind[i][2]+uinp[i][2])*cphi[i][3]); + vxy -= 0.5*(cphidp[i][1]*cmp[i][2]+cphidp[i][2]*cmp[i][1]) + + 0.25*((uind[i][1]+uinp[i][1])*cphi[i][1] + + (uind[i][0]+uinp[i][0])*cphi[i][2]); + vyz -= 0.5*(cphidp[i][2]*cmp[i][3]+cphidp[i][3]*cmp[i][2]) + + 0.25*((uind[i][2]+uinp[i][2])*cphi[i][2] + + (uind[i][1]+uinp[i][1])*cphi[i][3]); + vxz -= 0.5*(cphidp[i][1]*cmp[i][3]+cphidp[i][3]*cmp[i][1]) + + 0.25*((uind[i][2]+uinp[i][2])*cphi[i][1] + + (uind[i][0]+uinp[i][0])*cphi[i][3]); + + vxx -= 2.0*cmp[i][4]*cphidp[i][4] + cmp[i][7]*cphidp[i][7] + + cmp[i][8]*cphidp[i][8]; + vyy -= 2.0*cmp[i][5]*cphidp[i][5] + cmp[i][7]*cphidp[i][7] + + cmp[i][9]*cphidp[i][9]; + vzz -= 2.0*cmp[i][6]*cphidp[i][6] + cmp[i][8]*cphidp[i][8] + + cmp[i][9]*cphidp[i][9]; + vxy -= (cmp[i][4]+cmp[i][5])*cphidp[i][7] + + 0.5*(cmp[i][7]*(cphidp[i][5]+cphidp[i][4]) + + cmp[i][8]*cphidp[i][9]+cmp[i][9]*cphidp[i][8]); + vyz -= (cmp[i][5]+cmp[i][6])*cphidp[i][9] + + 0.5*(cmp[i][9]*(cphidp[i][5]+cphidp[i][6]) + + cmp[i][7]*cphidp[i][8]+cmp[i][8]*cphidp[i][7]); + vxz -= (cmp[i][4]+cmp[i][6])*cphidp[i][8] + + 0.5*(cmp[i][8]*(cphidp[i][4]+cphidp[i][6]) + + cmp[i][7]*cphidp[i][9]+cmp[i][9]*cphidp[i][7]); + + if (poltyp == MUTUAL) { + vxx -= 0.5 * (cphid[1]*uinp[i][0]+cphip[1]*uind[i][0]); + vyy -= 0.5 * (cphid[2]*uinp[i][1]+cphip[2]*uind[i][1]); + vzz -= 0.5 * (cphid[3]*uinp[i][2]+cphip[3]*uind[i][2]); + vxy -= 0.25 * (cphid[1]*uinp[i][1]+cphip[1]*uind[i][1] + + cphid[2]*uinp[i][0]+cphip[2]*uind[i][0]); + vyz -= 0.25 * (cphid[2]*uinp[i][2]+cphip[2]*uind[i][2] + + cphid[3]*uinp[i][1]+cphip[3]*uind[i][1]); + vxz -= 0.25 * (cphid[1]*uinp[i][2]+cphip[1]*uind[i][2] + + cphid[3]*uinp[i][0]+cphip[3]*uind[i][0]); + } + } + + + // resolve site torques then increment forces and virial + + for (i = 0; i < nlocal; i++) { + tep[0] = cmp[i][3]*cphidp[i][2] - cmp[i][2]*cphidp[i][3] + + 2.0*(cmp[i][6]-cmp[i][5])*cphidp[i][9] + cmp[i][8]*cphidp[i][7] + + cmp[i][9]*cphidp[i][5]- cmp[i][7]*cphidp[i][8] - cmp[i][9]*cphidp[i][6]; + tep[1] = cmp[i][1]*cphidp[i][3] - cmp[i][3]*cphidp[i][1] + + 2.0*(cmp[i][4]-cmp[i][6])*cphidp[i][8] + cmp[i][7]*cphidp[i][9] + + cmp[i][8]*cphidp[i][6] - cmp[i][8]*cphidp[i][4] - cmp[i][9]*cphidp[i][7]; + tep[2] = cmp[i][2]*cphidp[i][1] - cmp[i][1]*cphidp[i][2] + + 2.0*(cmp[i][5]-cmp[i][4])*cphidp[i][7] + cmp[i][7]*cphidp[i][4] + + cmp[i][9]*cphidp[i][8] - cmp[i][7]*cphidp[i][5] - cmp[i][8]*cphidp[i][9]; + + torque2force(i,tep,fix,fiy,fiz,fpolar); + + iz = zaxis2local[i]; + ix = xaxis2local[i]; + iy = yaxis2local[i]; + + xiz = x[iz][0] - x[i][0]; + yiz = x[iz][1] - x[i][1]; + ziz = x[iz][2] - x[i][2]; + xix = x[ix][0] - x[i][0]; + yix = x[ix][1] - x[i][1]; + zix = x[ix][2] - x[i][2]; + xiy = x[iy][0] - x[i][0]; + yiy = x[iy][1] - x[i][1]; + ziy = x[iy][2] - x[i][2]; + + vxx += xix*fix[0] + xiy*fiy[0] + xiz*fiz[0]; + vyy += yix*fix[1] + yiy*fiy[1] + yiz*fiz[1]; + vzz += zix*fix[2] + ziy*fiy[2] + ziz*fiz[2]; + vxy += 0.5*(yix*fix[0] + yiy*fiy[0] + yiz*fiz[0] + + xix*fix[1] + xiy*fiy[1] + xiz*fiz[1]); + vyz += 0.5*(zix*fix[1] + ziy*fiy[1] + ziz*fiz[1] + + yix*fix[2] + yiy*fiy[2] + yiz*fiz[2]); + vxz += 0.5*(zix*fix[0] + ziy*fiy[0] + ziz*fiz[0] + + xix*fix[2] + xiy*fiy[2] + xiz*fiz[2]); + } + + // account for dipole response terms in the OPT method + + if (poltyp == OPT) { + for (i = 0; i < nlocal; i++) { + for (k = 0; k < optorder; k++) { + for (j = 1; j < 10; j++) { + fphid[i][j] = felec * fopt[i][k][j]; + fphip[i][j] = felec * foptp[i][k][j]; + } + + for (m = 0; m < optorder-k; m++) { + for (j = 0; j < 3; j++) { + fuind[i][j] = a[0][j]*uopt[i][m][0] + a[1][j]*uopt[i][m][1] + + a[2][j]*uopt[i][m][2]; + fuinp[i][j] = a[0][j]*uoptp[i][m][0] + a[1][j]*uoptp[i][m][1] + + a[2][j]*uoptp[i][m][2]; + } + + f1 = 0.0; + f2 = 0.0; + f3 = 0.0; + + for (j = 0; j < 3; j++) { + j1 = deriv1[j+1]; + j2 = deriv2[j+1]; + j3 = deriv3[j+1]; + f1 += fuind[i][j]*fphip[i][j1] + fuinp[i][j]*fphid[i][j1]; + f2 += fuind[i][j]*fphip[i][j2] + fuinp[i][j]*fphid[i][j2]; + f3 += fuind[i][j]*fphip[i][j3] + fuinp[i][j]*fphid[i][j3]; + } + + f1 *= 0.5 * nfft1; + f2 *= 0.5 * nfft2; + f3 *= 0.5 * nfft3; + h1 = recip[0][0]*f1 + recip[0][1]*f2 + recip[0][2]*f3; + h2 = recip[1][0]*f1 + recip[1][1]*f2 + recip[1][2]*f3; + h3 = recip[2][0]*f1 + recip[2][1]*f2 + recip[2][2]*f3; + + fpolar[i][0] += copm[k+m+1]*h1; + fpolar[i][1] += copm[k+m+1]*h2; + fpolar[i][2] += copm[k+m+1]*h3; + + for (j = 1; j < 4; j++) { + cphid[j] = 0.0; + cphip[j] = 0.0; + for (j1 = 1; j1 < 4; j1++) { + cphid[j] += ftc[j][j1]*fphid[i][j1]; + cphip[j] += ftc[j][j1]*fphip[i][j1]; + } + } + + vxx -= 0.5*copm[k+m+1] * + (cphid[1]*uoptp[i][m][0] + cphip[1]*uopt[i][m][0]); + vyy -= 0.5*copm[k+m+1] * + (cphid[2]*uoptp[i][m][1]+ cphip[2]*uopt[i][m][1]); + vzz -= 0.5*copm[k+m+1] * + (cphid[3]*uoptp[i][m][2]+ cphip[3]*uopt[i][m][2]); + vxy -= 0.25*copm[k+m+1] * + (cphid[1]*uoptp[i][m][1]+ cphip[1]*uopt[i][m][1]+ + cphid[2]*uoptp[i][m][0]+ cphip[2]*uopt[i][m][0]); + vyz -= 0.25*copm[k+m+1] * + (cphid[1]*uoptp[i][m][2]+ cphip[1]*uopt[i][m][2]+ + cphid[3]*uoptp[i][m][0]+ cphip[3]*uopt[i][m][0]); + vxz -= 0.25*copm[k+m+1] * + (cphid[2]*uoptp[i][m][2]+ cphip[2]*uopt[i][m][2]+ + cphid[3]*uoptp[i][m][1]+ cphip[3]*uopt[i][m][1]); + } + } + } + } + + // account for dipole response terms in the TCG method + + /* + if (poltyp == TCG) { + + for (m = 0; m < tcgnab; m++) { + for (i = 0; i < nlocal; i++) { + for (j = 0; j < 3; j++) { + fuind[i][j] = a[0][j]*uad[i][m][0] + a[1][j]*uad[i][m][1] + + a[2][j]*uad[i][m][2]; + fuinp[i][j] = a[0][j]*ubp[i][m][0] + a[1][j]*ubp[i][m][1] + + a[2][j]*ubp[i][m][2]; + } + } + + grid_uind(fuind,fuinp); + efft->compute(qgrid[0][0][0],qgrid[0][0][0],1); + + for (k = 0; k < nfft3; k++) { + for (j = 0; j < nfft2; j++) { + for (i = 0; i < nfft1; i++) { + term = qfac[k][j][i]; + qgrid[k][j][i][0] *= term; + qgrid[k][j][i][1] *= term; + } + } + } + + efft->compute(qgrid[0][0][0],qgrid[0][0][0],-1); + fphi_uind(fphid,fphip,fphidp); + + for (i = 0; i < nlocal; i++) { + for (j = 1; j < 10; j++) { + fphid[i][j] *= felec; + fphip[i][j] *= felec; + } + } + + for (i = 0; i < nlocal; i++) { + f1 = 0.0; + f2 = 0.0; + f3 = 0.0; + for (k = 0; k < 3; k++) { + j1 = deriv1[k+1]; + j2 = deriv2[k+1]; + j3 = deriv3[k+1]; + f1 += fuind[i][k]*fphip[i][j1]+fuinp[i][k]*fphid[i][j1]; + f2 += fuind[i][k]*fphip[i][j2]+fuinp[i][k]*fphid[i][j2]; + f3 += fuind[i][k]*fphip[i][j3]+fuinp[i][k]*fphid[i][j3]; + } + + f1 *= 0.5 * nfft1; + f2 *= 0.5 * nfft2; + f3 *= 0.5 * nfft3; + h1 = recip[0][0]*f1 + recip[0][1]*f2 + recip[0][2]*f3; + h2 = recip[1][0]*f1 + recip[1][1]*f2 + recip[1][2]*f3; + h3 = recip[2][0]*f1 + recip[2][1]*f2 + recip[2][2]*f3; + fpolar[i][0] += h1; + fpolar[i][1] += h2; + fpolar[i][2] += h3; + + for (j = 1; j < 4; j++) { + cphid[j] = 0.0; + cphip[j] = 0.0; + for (k = 1; k < 4; k++) { + cphid[j] += ftc[j][k]*fphid[i][k]; + cphip[j] += ftc[j][k]*fphip[i][k]; + } + } + + vxx -= 0.5*(cphid[1]*ubp[i][m][0] + cphip[1]*uad[i][m][0]); + vyy -= 0.5*(cphid[2]*ubp[i][m][1] + cphip[2]*uad[i][m][1]); + vzz -= 0.5*(cphid[3]*ubp[i][m][2] + cphip[3]*uad[i][m][2]); + + vxy -= 0.25*(cphid[1]*ubp[i][m][1] + cphip[1]*uad[i][m][1] + + cphid[2]*ubp[i][m][0] + cphip[2]*uad[i][m][0]); + vyz -= 0.25*(cphid[1]*ubp[i][m][2] + cphip[1]*uad[i][m][2] + + cphid[3]*ubp[i][m][0] + cphip[3]*uad[i][m][0]); + vxz -= 0.25*(cphid[2]*ubp[i][m][2] + cphip[2]*uad[i][m][2] + + cphid[3]*ubp[i][m][1] + cphip[3]*uad[i][m][1]); + } + + for (i = 0; i < nlocal; i++) { + for (j = 0; j < 3; j++) { + fuind[i][j] = a[0][j]*ubd[i][m][0] + a[1][j]*ubd[i][m][1] + + a[2][j]*ubd[i][m][2]; + fuinp[i][j] = a[0][j]*uap[i][m][0] + a[1][j]*uap[i][m][1] + + a[2][j]*uap[i][m][2]; + } + } + + grid_uind(fuind,fuinp); + efft->compute(qgrid[0][0][0],qgrid[0][0][0],1); + + for (k = 0; k < nfft3; k++) { + for (j = 0; j < nfft2; j++) { + for (i = 0; i < nfft1; i++) { + term = qfac[k][j][i]; + qgrid[k][j][i][0] *= term; + qgrid[k][j][i][1] *= term; + } + } + } + + efft->compute(qgrid[0][0][0],qgrid[0][0][0],-1); + fphi_uind(fphid,fphip,fphidp); + + for (i = 0; i < nlocal; i++) { + for (j = 1; j < 10; j++) { + fphid[i][j] *= felec; + fphip[i][j] *= felec; + } + } + + for (i = 0; i < nlocal; i++) { + f1 = 0.0; + f2 = 0.0; + f3 = 0.0; + for (k = 0; k < 3; k++) { + j1 = deriv1[k+1]; + j2 = deriv2[k+1]; + j3 = deriv3[k+1]; + f1 += fuind[i][k]*fphip[i][j1]+fuinp[i][k]*fphid[i][j1]; + f2 += fuind[i][k]*fphip[i][j2]+fuinp[i][k]*fphid[i][j2]; + f3 += fuind[i][k]*fphip[i][j3]+fuinp[i][k]*fphid[i][j3]; + } + + f1 *= 0.5 * nfft1; + f2 *= 0.5 * nfft2; + f3 *= 0.5 * nfft3; + h1 = recip[0][0]*f1 + recip[0][1]*f2 + recip[0][2]*f3; // matvec + h2 = recip[1][0]*f1 + recip[1][1]*f2 + recip[1][2]*f3; + h3 = recip[2][0]*f1 + recip[2][1]*f2 + recip[2][2]*f3; + fpolar[i][0] += h1; + fpolar[i][1] += h2; + fpolar[i][2] += h3; + + for (j = 1; j < 4; j++) { + cphid[j] = 0.0; + cphip[j] = 0.0; + for (k = 1; k < 4; k++) { + cphid[j] += ftc[j][k]*fphid[i][k]; + cphip[j] += ftc[j][k]*fphip[i][k]; + } + } + + vxx -= 0.5*(cphid[1]*uap[i][m][0] + cphip[1]*ubd[i][m][0]); + vyy -= 0.5*(cphid[2]*uap[i][m][1] + cphip[2]*ubd[i][m][1]); + vzz -= 0.5*(cphid[3]*uap[i][m][2] + cphip[3]*ubd[i][m][2]); + vxy -= 0.25*(cphid[1]*uap[i][m][1] + cphip[1]*ubd[i][m][1] + + cphid[2]*uap[i][m][0] + cphip[2]*ubd[i][m][0]); + vxz -= 0.25*(cphid[1]*uap[i][m][2] + cphip[1]*ubd[i][m][2] + + cphid[3]*uap[i][m][0] + cphip[3]*ubd[i][m][0]); + vyz -= 0.25*(cphid[2]*uap[i][m][2] + cphip[2]*ubd[i][m][2] + + cphid[3]*uap[i][m][1] + cphip[3]*ubd[i][m][1]); + } + } + } + */ + + // assign permanent and induced multipoles to the PME grid + + for (i = 0; i < nlocal; i++) { + for (j = 1; j < 4; j++) + cmp[i][j] += uinp[i][j-1]; + } + + // convert Cartesian multipoles to fractional multipoles + + cmp_to_fmp(cmp,fmp); + + // gridpre = my portion of 3d grid in brick decomp w/ ghost values + // zeroed by zero() + + double ***gridpre = (double ***) p_kspace->zero(); + + // DEBUG + + double psum = 0.0; + for (k = p_kspace->nzlo_out; k <= p_kspace->nzhi_out; k++) { + for (j = p_kspace->nylo_out; j <= p_kspace->nyhi_out; j++) { + for (i = p_kspace->nxlo_out; i <= p_kspace->nxhi_out; i++) { + psum += gridpre[k][j][i]; + } + } + } + + // map atoms to grid + + grid_mpole(fmp,gridpre); + + // pre-convolution operations including forward FFT + // gridfft = my portion of complex 3d grid in FFT decomp as 1d vector + + gridfft = p_kspace->pre_convolution(); + + // gridfft1 = copy of first FFT + // NOTE: need to allocate this, when is it freed? + + FFT_SCALAR *gridfft1; + int nfft_owned = p_kspace->nfft_owned; + memory->create(gridfft1,2*nfft_owned,"amoeba:gridfft1"); + memcpy(gridfft1,gridfft,2*nfft_owned*sizeof(FFT_SCALAR)); + + // assign induced dipoles to the PME grid + + for (i = 0; i < nlocal; i++) { + for (j = 1; j < 4; j++) + cmp[i][j] += uind[i][j-1] - uinp[i][j-1]; + } + + // convert Cartesian multipoles to fractional multipoles + + cmp_to_fmp(cmp,fmp); + + // gridpre = my portion of 3d grid in brick decomp w/ ghost values + // zeroed by zero() + + gridpre = (double ***) p_kspace->zero(); + + // map atoms to grid + + grid_mpole(fmp,gridpre); + + // pre-convolution operations including forward FFT + // gridfft1/2 = my portions of complex 3d grid in FFT decomp as 1d vectors + + double *gridfft2 = p_kspace->pre_convolution(); + + // --------------------- + // convolution operation + // --------------------- + + m = n = 0; + for (k = nzlo; k <= nzhi; k++) { + for (j = nylo; j <= nyhi; j++) { + for (i = nxlo; i <= nxhi; i++) { + r1 = (i >= nhalf1) ? i-nfft1 : i; + r2 = (j >= nhalf2) ? j-nfft2 : j; + r3 = (k >= nhalf3) ? k-nfft3 : k; + h1 = recip[0][0]*r1 + recip[0][1]*r2 + recip[0][2]*r3; // matvec + h2 = recip[1][0]*r1 + recip[1][1]*r2 + recip[1][2]*r3; + h3 = recip[2][0]*r1 + recip[2][1]*r2 + recip[2][2]*r3; + hsq = h1*h1 + h2*h2 + h3*h3; + term = -pterm * hsq; + expterm = 0.0; + if (term > -50.0 && hsq != 0.0) { + denom = volterm*hsq*bsmod1[i]*bsmod2[j]*bsmod3[k]; + expterm = exp(term) / denom; + struc2 = gridfft1[n]*gridfft2[n] + gridfft1[n+1]*gridfft2[n+1]; + eterm = 0.5 * felec * expterm * struc2; + vterm = (2.0/hsq) * (1.0-term) * eterm; + vxx += h1*h1*vterm - eterm; + vyy += h2*h2*vterm - eterm; + vzz += h3*h3*vterm - eterm; + vxy += h1*h2*vterm; + vyz += h2*h3*vterm; + vxz += h1*h3*vterm; + } + n += 2; + } + } + } + + // assign only the induced dipoles to the PME grid + // and perform the 3-D FFT forward transformation + // NOTE: why is there no inverse FFT in this section? + + if (poltyp == DIRECT || poltyp == TCG) { + + for (i = 0; i < nlocal; i++) { + for (j = 0; j < 10; j++) + cmp[i][j] = 0.0; + for (j = 1; j < 4; j++) + cmp[i][j] = uinp[i][j-1]; + } + + // convert Cartesian multipoles to fractional multipoles + + cmp_to_fmp(cmp,fmp); + + // gridpre = my portion of 3d grid in brick decomp w/ ghost values + // zeroed by zero() + + double ***gridpre = (double ***) p_kspace->zero(); + + // map atoms to grid + + grid_mpole(fmp,gridpre); + + // pre-convolution operations including forward FFT + // gridfft = my portion of complex 3d grid in FFT decomp as 1d vector + + double *gridfft = p_kspace->pre_convolution(); + + // gridfft1 = copy of first FFT + // NOTE: do this same as above + + int nfft_owned = p_kspace->nfft_owned; + memcpy(gridfft1,gridfft,2*nfft_owned*sizeof(double)); + + // assign ??? to the PME grid + + for (i = 0; i < nlocal; i++) { + for (j = 1; j < 4; j++) + cmp[i][j] = uind[i][j-1]; + } + + // convert Cartesian multipoles to fractional multipoles + + cmp_to_fmp(cmp,fmp); + + // gridpre = my portion of 3d grid in brick decomp w/ ghost values + + gridpre = (double ***) p_kspace->zero(); + + // map atoms to grid + + grid_mpole(fmp,gridpre); + + // pre-convolution operations including forward FFT + // gridfft = my portion of complex 3d grid in FFT decomp as 1d vector + + double *gridfft2 = p_kspace->pre_convolution(); + + // --------------------- + // convolution operation + // --------------------- + + m = n = 0; + for (k = nzlo; k <= nzhi; k++) { + for (j = nylo; j <= nyhi; j++) { + for (i = nxlo; i <= nxhi; i++) { + r1 = (i >= nhalf1) ? i-nfft1 : i; + r2 = (j >= nhalf2) ? j-nfft2 : j; + r3 = (k >= nhalf3) ? k-nfft3 : k; + h1 = recip[0][0]*r1 + recip[0][1]*r2 + recip[0][2]*r3; // matvec + h2 = recip[1][0]*r1 + recip[1][1]*r2 + recip[1][2]*r3; + h3 = recip[2][0]*r1 + recip[2][1]*r2 + recip[2][2]*r3; + hsq = h1*h1 + h2*h2 + h3*h3; + term = -pterm * hsq; + expterm = 0.0; + if (term > -50.0 && hsq != 0.0) { + denom = volterm*hsq*bsmod1[i]*bsmod2[j]*bsmod3[k]; + expterm = exp(term) / denom; + struc2 = gridfft1[n]*gridfft2[n] + gridfft1[n+1]*gridfft2[n+1]; + eterm = 0.5 * felec * expterm * struc2; + vterm = (2.0/hsq) * (1.0-term) * eterm; + vxx += h1*h1*vterm - eterm; + vyy += h2*h2*vterm - eterm; + vzz += h3*h3*vterm - eterm; + vxy += h1*h2*vterm; + vyz += h2*h3*vterm; + vxz += h1*h3*vterm; + } + n += 2; + } + } + } + } + + // add back missing terms for the TCG polarization method; + // first do the term for "UAD" dotted with "UBP" + + /* + if (poltyp == TCG) { + + for (m = 0; m < tcgnab; m++) { + for (i = 0; i < nlocal; i++) { + for (j = 0; j < 10; j++) + cmp[i][j] = 0.0; + for (j = 1; j < 4; j++) + cmp[i][j] = ubp[i][m][j-1]; + } + + cmp_to_fmp(cmp,fmp); + grid_mpole(fmp); + efft->compute(qgrid[0][0][0],qgrid[0][0][0],1); + + for (k = 0; k < nfft3; k++) { + for (j = 0; j < nfft2; j++) { + for (i = 0; i < nfft1; i++) { + qgrip[k][j][i][0] = qgrid[k][j][i][0]; + qgrip[k][j][i][1] = qgrid[k][j][i][1]; + } + } + } + + for (i = 0; i < nlocal; i++) { + for (j = 1; j < 4; j++) + cmp[i][j] = uad[i][m][j-1]; + } + + cmp_to_fmp(cmp,fmp); + grid_mpole(fmp); + efft->compute(qgrid[0][0][0],qgrid[0][0][0],1); + + // make the scalar summation over reciprocal lattice + // NOTE: this loop has to be distributed for parallel + // NOTE: why does this one include m = 0 ? + + for (m = 1; m < ntot; m++) { + k1 = m % nfft1; + k2 = (m % nff) / nfft1; + k3 = m/nff; + r1 = (k1 >= nf1) ? k1-nfft1 : k1; + r2 = (k2 >= nf2) ? k2-nfft2 : k2; + r3 = (k3 >= nf3) ? k3-nfft3 : k3; + h1 = recip[0][0]*r1 + recip[0][1]*r2 + recip[0][2]*r3; + h2 = recip[1][0]*r1 + recip[1][1]*r2 + recip[1][2]*r3; + h3 = recip[2][0]*r1 + recip[2][1]*r2 + recip[2][2]*r3; + hsq = h1*h1 + h2*h2 + h3*h3; + term = -pterm * hsq; + expterm = 0.0; + if (term > -50.0 && hsq != 0.0) { + denom = volterm*hsq*bsmod1[k1]*bsmod2[k2]*bsmod3[k3]; + expterm = exp(term) / denom; + struc2 = qgrid[k3][k2][k1][0]*qgrip[k3][k2][k1][0] + + qgrid[k3][k2][k1][1]*qgrip[k3][k2][k1][1]; + eterm = 0.5 * felec * expterm * struc2; + vterm = (2.0/hsq) * (1.0-term) * eterm; + virpolar[0] += h1*h1*vterm - eterm; + virpolar[1] += h2*h2*vterm - eterm; + virpolar[2] += h3*h3*vterm - eterm; + virpolar[3] += h1*h2*vterm; + virpolar[4] += h1*h3*vterm; + virpolar[5] += h2*h3*vterm; + } + } + + // now do the TCG terms with "UBD" dotted with "UAP" + + for (i = 0; i < nlocal; i++) { + for (j = 0; j < 10; j++) + cmp[i][j] = 0.0; + for (j = 1; j < 4; j++) + cmp[i][j] = uap[i][m][j-1]; + } + + cmp_to_fmp(cmp,fmp); + grid_mpole(fmp); + efft->compute(qgrid[0][0][0],qgrid[0][0][0],1); + + for (k = 0; k < nfft3; k++) { + for (j = 0; j < nfft2; j++) { + for (i = 0; i < nfft1; i++) { + qgrip[k][j][i][0] = qgrid[k][j][i][0]; + qgrip[k][j][i][1] = qgrid[k][j][i][1]; + } + } + } + + for (i = 0; i < nlocal; i++) { + for (j = 1; j < 4; j++) + cmp[i][j] = ubd[i][m][j-1]; + } + + cmp_to_fmp(cmp,fmp); + grid_mpole(fmp); + efft->compute(qgrid[0][0][0],qgrid[0][0][0],1); + + // make the scalar summation over reciprocal lattice + // NOTE: this loop has to be distributed for parallel + // NOTE: why does this one include m = 0 ? + + for (m = 1; m < ntot; m++) { + k1 = m % nfft1; + k2 = (m % nff) / nfft1; + k3 = m/nff; + r1 = (k1 >= nf1) ? k1-nfft1 : k1; + r2 = (k2 >= nf2) ? k2-nfft2 : k2; + r3 = (k3 >= nf3) ? k3-nfft3 : k3; + h1 = recip[0][0]*r1 + recip[0][1]*r2 + recip[0][2]*r3; + h2 = recip[1][0]*r1 + recip[1][1]*r2 + recip[1][2]*r3; + h3 = recip[2][0]*r1 + recip[2][1]*r2 + recip[2][2]*r3; + hsq = h1*h1 + h2*h2 + h3*h3; + term = -pterm * hsq; + expterm = 0.0; + if (term > -50.0 && hsq != 0.0) { + denom = volterm*hsq*bsmod1[k1]*bsmod2[k2]*bsmod3[k3]; + expterm = exp(term) / denom; + struc2 = qgrid[k3][k2][k1][0]*qgrip[k3][k2][k1][0] + + qgrid[k3][k2][k1][1]*qgrip[k3][k2][k1][1]; + eterm = 0.5 * felec * expterm * struc2; + vterm = (2.0/hsq) * (1.0-term) * eterm; + virpolar[0] += h1*h1*vterm - eterm; + virpolar[1] += h2*h2*vterm - eterm; + virpolar[2] += h3*h3*vterm - eterm; + virpolar[3] += h1*h2*vterm; + virpolar[4] += h1*h3*vterm; + virpolar[5] += h2*h3*vterm; + } + } + } + } + */ + + // increment the total internal virial tensor components + + virpolar[0] += vxx; + virpolar[1] += vyy; + virpolar[2] += vzz; + virpolar[3] += vxy; + virpolar[4] += vxz; + virpolar[5] += vyz; + + // deallocation of local arrays, some from induce + + memory->destroy(gridfft1); + memory->destroy(cmp); + memory->destroy(fmp); + memory->destroy(cphi); + memory->destroy(fphi); + memory->destroy(fuind); + memory->destroy(fuinp); + memory->destroy(fphid); + memory->destroy(fphip); + memory->destroy(fphidp); + memory->destroy(cphidp); +} diff --git a/src/AMOEBA/amoeba_repulsion.cpp b/src/AMOEBA/amoeba_repulsion.cpp new file mode 100644 index 0000000000..11c4f821c2 --- /dev/null +++ b/src/AMOEBA/amoeba_repulsion.cpp @@ -0,0 +1,581 @@ +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#include "pair_amoeba.h" +#include +#include "atom.h" +#include "comm.h" +#include "neigh_list.h" +#include "memory.h" + +using namespace LAMMPS_NS; + +enum{FIELD,ZRSD,TORQUE,UFLD}; // reverse comm +enum{VDWL,REPULSE,QFER,DISP,MPOLE,POLAR,USOLV,DISP_LONG,MPOLE_LONG,POLAR_LONG}; + +/* ---------------------------------------------------------------------- + repulsion = Pauli repulsion interactions + adapted from Tinker erepel1b() routine +------------------------------------------------------------------------- */ + +void PairAmoeba::repulsion() +{ + int i,j,k,ii,jj,itype,jtype; + int ix,iy,iz; + double e; + double eterm,de; + double xi,yi,zi; + double xr,yr,zr; + double xix,yix,zix; + double xiy,yiy,ziy; + double xiz,yiz,ziz; + double r,r2,r3,r4,r5; + double rr1,rr3,rr5; + double rr7,rr9,rr11; + double ci,dix,diy,diz; + double qixx,qixy,qixz; + double qiyy,qiyz,qizz; + double ck,dkx,dky,dkz; + double qkxx,qkxy,qkxz; + double qkyy,qkyz,qkzz; + double dir,dkr,dik,qik; + double qix,qiy,qiz,qir; + double qkx,qky,qkz,qkr; + double diqk,dkqi,qiqk; + double dirx,diry,dirz; + double dkrx,dkry,dkrz; + double dikx,diky,dikz; + double qirx,qiry,qirz; + double qkrx,qkry,qkrz; + double qikx,qiky,qikz; + double qixk,qiyk,qizk; + double qkxi,qkyi,qkzi; + double qikrx,qikry,qikrz; + double qkirx,qkiry,qkirz; + double diqkx,diqky,diqkz; + double dkqix,dkqiy,dkqiz; + double diqkrx,diqkry,diqkrz; + double dkqirx,dkqiry,dkqirz; + double dqikx,dqiky,dqikz; + double term1,term2,term3; + double term4,term5,term6; + double sizi,sizk,sizik; + double vali,valk; + double dmpi,dmpk; + double frcx,frcy,frcz; + double taper,dtaper; + double vxx,vyy,vzz; + double vxy,vxz,vyz; + double factor_repel; + double ttri[3],ttrk[3]; + double fix[3],fiy[3],fiz[3]; + double dmpik[11]; + + int inum,jnum; + int *ilist,*jlist,*numneigh,**firstneigh; + + // set cutoffs and taper coeffs + + choose(REPULSE); + + // owned atoms + + double **x = atom->x; + int nlocal = atom->nlocal; + + // zero repulsion torque on owned + ghost atoms + + int nall = nlocal + atom->nghost; + + for (i = 0; i < nall; i++) { + tq[i][0] = 0.0; + tq[i][1] = 0.0; + tq[i][2] = 0.0; + } + + // neigh list + + inum = list->inum; + ilist = list->ilist; + numneigh = list->numneigh; + firstneigh = list->firstneigh; + + // double loop over owned atoms and neighbors + + // DEBUG + //FILE *fp = fopen("lammps.dat","w"); + + for (ii = 0; ii < inum; ii++) { + i = ilist[ii]; + itype = amtype[i]; + jlist = firstneigh[i]; + jnum = numneigh[i]; + + xi = x[i][0]; + yi = x[i][1]; + zi = x[i][2]; + sizi = sizpr[itype]; + dmpi = dmppr[itype]; + vali = elepr[itype]; + ci = rpole[i][0]; + dix = rpole[i][1]; + diy = rpole[i][2]; + diz = rpole[i][3]; + qixx = rpole[i][4]; + qixy = rpole[i][5]; + qixz = rpole[i][6]; + qiyy = rpole[i][8]; + qiyz = rpole[i][9]; + qizz = rpole[i][12]; + + for (jj = 0; jj < jnum; jj++) { + j = jlist[jj]; + factor_repel = special_repel[sbmask15(j)]; + if (factor_repel == 0.0) continue; + j &= NEIGHMASK15; + + xr = x[j][0] - xi; + yr = x[j][1] - yi; + zr = x[j][2] - zi; + r2 = xr*xr + yr*yr + zr*zr; + if (r2 > off2) continue; + + jtype = amtype[j]; + + r = sqrt(r2); + sizk = sizpr[jtype]; + dmpk = dmppr[jtype]; + valk = elepr[jtype]; + ck = rpole[j][0]; + dkx = rpole[j][1]; + dky = rpole[j][2]; + dkz = rpole[j][3]; + qkxx = rpole[j][4]; + qkxy = rpole[j][5]; + qkxz = rpole[j][6]; + qkyy = rpole[j][8]; + qkyz = rpole[j][9]; + qkzz = rpole[j][12]; + + // intermediates involving moments and separation distance + + dir = dix*xr + diy*yr + diz*zr; + qix = qixx*xr + qixy*yr + qixz*zr; + qiy = qixy*xr + qiyy*yr + qiyz*zr; + qiz = qixz*xr + qiyz*yr + qizz*zr; + qir = qix*xr + qiy*yr + qiz*zr; + dkr = dkx*xr + dky*yr + dkz*zr; + qkx = qkxx*xr + qkxy*yr + qkxz*zr; + qky = qkxy*xr + qkyy*yr + qkyz*zr; + qkz = qkxz*xr + qkyz*yr + qkzz*zr; + qkr = qkx*xr + qky*yr + qkz*zr; + dik = dix*dkx + diy*dky + diz*dkz; + qik = qix*qkx + qiy*qky + qiz*qkz; + diqk = dix*qkx + diy*qky + diz*qkz; + dkqi = dkx*qix + dky*qiy + dkz*qiz; + qiqk = 2.0*(qixy*qkxy+qixz*qkxz+qiyz*qkyz) + + qixx*qkxx + qiyy*qkyy + qizz*qkzz; + + // additional intermediates involving moments and distance + + dirx = diy*zr - diz*yr; + diry = diz*xr - dix*zr; + dirz = dix*yr - diy*xr; + dkrx = dky*zr - dkz*yr; + dkry = dkz*xr - dkx*zr; + dkrz = dkx*yr - dky*xr; + dikx = diy*dkz - diz*dky; + diky = diz*dkx - dix*dkz; + dikz = dix*dky - diy*dkx; + qirx = qiz*yr - qiy*zr; + qiry = qix*zr - qiz*xr; + qirz = qiy*xr - qix*yr; + qkrx = qkz*yr - qky*zr; + qkry = qkx*zr - qkz*xr; + qkrz = qky*xr - qkx*yr; + qikx = qky*qiz - qkz*qiy; + qiky = qkz*qix - qkx*qiz; + qikz = qkx*qiy - qky*qix; + qixk = qixx*qkx + qixy*qky + qixz*qkz; + qiyk = qixy*qkx + qiyy*qky + qiyz*qkz; + qizk = qixz*qkx + qiyz*qky + qizz*qkz; + qkxi = qkxx*qix + qkxy*qiy + qkxz*qiz; + qkyi = qkxy*qix + qkyy*qiy + qkyz*qiz; + qkzi = qkxz*qix + qkyz*qiy + qkzz*qiz; + qikrx = qizk*yr - qiyk*zr; + qikry = qixk*zr - qizk*xr; + qikrz = qiyk*xr - qixk*yr; + qkirx = qkzi*yr - qkyi*zr; + qkiry = qkxi*zr - qkzi*xr; + qkirz = qkyi*xr - qkxi*yr; + diqkx = dix*qkxx + diy*qkxy + diz*qkxz; + diqky = dix*qkxy + diy*qkyy + diz*qkyz; + diqkz = dix*qkxz + diy*qkyz + diz*qkzz; + dkqix = dkx*qixx + dky*qixy + dkz*qixz; + dkqiy = dkx*qixy + dky*qiyy + dkz*qiyz; + dkqiz = dkx*qixz + dky*qiyz + dkz*qizz; + diqkrx = diqkz*yr - diqky*zr; + diqkry = diqkx*zr - diqkz*xr; + diqkrz = diqky*xr - diqkx*yr; + dkqirx = dkqiz*yr - dkqiy*zr; + dkqiry = dkqix*zr - dkqiz*xr; + dkqirz = dkqiy*xr - dkqix*yr; + dqikx = diy*qkz - diz*qky + dky*qiz - dkz*qiy - + 2.0*(qixy*qkxz+qiyy*qkyz+qiyz*qkzz-qixz*qkxy-qiyz*qkyy-qizz*qkyz); + dqiky = diz*qkx - dix*qkz + dkz*qix - dkx*qiz - + 2.0*(qixz*qkxx+qiyz*qkxy+qizz*qkxz-qixx*qkxz-qixy*qkyz-qixz*qkzz); + dqikz = dix*qky - diy*qkx + dkx*qiy - dky*qix - + 2.0*(qixx*qkxy+qixy*qkyy+qixz*qkyz-qixy*qkxx-qiyy*qkxy-qiyz*qkxz); + + // get reciprocal distance terms for this interaction + + rr1 = 1.0 / r; + rr3 = rr1 / r2; + rr5 = 3.0 * rr3 / r2; + rr7 = 5.0 * rr5 / r2; + rr9 = 7.0 * rr7 / r2; + rr11 = 9.0 * rr9 / r2; + + // get damping coefficients for the Pauli repulsion energy + + damprep(r,r2,rr1,rr3,rr5,rr7,rr9,rr11,11,dmpi,dmpk,dmpik); + + // calculate intermediate terms needed for the energy + + term1 = vali*valk; + term2 = valk*dir - vali*dkr + dik; + term3 = vali*qkr + valk*qir - dir*dkr + 2.0*(dkqi-diqk+qiqk); + term4 = dir*qkr - dkr*qir - 4.0*qik; + term5 = qir*qkr; + eterm = term1*dmpik[0] + term2*dmpik[2] + + term3*dmpik[4] + term4*dmpik[6] + term5*dmpik[8]; + + // compute the Pauli repulsion energy for this interaction + + sizik = sizi * sizk * factor_repel; + e = sizik * eterm * rr1; + + // calculate intermediate terms for force and torque + + de = term1*dmpik[2] + term2*dmpik[4] + term3*dmpik[6] + + term4*dmpik[8] + term5*dmpik[10]; + term1 = -valk*dmpik[2] + dkr*dmpik[4] - qkr*dmpik[6]; + term2 = vali*dmpik[2] + dir*dmpik[4] + qir*dmpik[6]; + term3 = 2.0 * dmpik[4]; + term4 = 2.0 * (-valk*dmpik[4] + dkr*dmpik[6] - qkr*dmpik[8]); + term5 = 2.0 * (-vali*dmpik[4] - dir*dmpik[6] - qir*dmpik[8]); + term6 = 4.0 * dmpik[6]; + + // compute the force components for this interaction + + frcx = de*xr + term1*dix + term2*dkx + term3*(diqkx-dkqix) + + term4*qix + term5*qkx + term6*(qixk+qkxi); + frcy = de*yr + term1*diy + term2*dky + term3*(diqky-dkqiy) + + term4*qiy + term5*qky + term6*(qiyk+qkyi); + frcz = de*zr + term1*diz + term2*dkz + term3*(diqkz-dkqiz) + + term4*qiz + term5*qkz + term6*(qizk+qkzi); + frcx = frcx*rr1 + eterm*rr3*xr; + frcy = frcy*rr1 + eterm*rr3*yr; + frcz = frcz*rr1 + eterm*rr3*zr; + frcx = sizik * frcx; + frcy = sizik * frcy; + frcz = sizik * frcz; + + // compute the torque components for this interaction + + ttri[0] = -dmpik[2]*dikx + term1*dirx + term3*(dqikx+dkqirx) - + term4*qirx - term6*(qikrx+qikx); + ttri[1] = -dmpik[2]*diky + term1*diry + term3*(dqiky+dkqiry) - + term4*qiry - term6*(qikry+qiky); + ttri[2] = -dmpik[2]*dikz + term1*dirz + term3*(dqikz+dkqirz) - + term4*qirz - term6*(qikrz+qikz); + ttrk[0] = dmpik[2]*dikx + term2*dkrx - term3*(dqikx+diqkrx) - + term5*qkrx - term6*(qkirx-qikx); + ttrk[1] = dmpik[2]*diky + term2*dkry - term3*(dqiky+diqkry) - + term5*qkry - term6*(qkiry-qiky); + ttrk[2] = dmpik[2]*dikz + term2*dkrz - term3*(dqikz+diqkrz) - + term5*qkrz - term6*(qkirz-qikz); + ttri[0] = sizik * ttri[0] * rr1; + ttri[1] = sizik * ttri[1] * rr1; + ttri[2] = sizik * ttri[2] * rr1; + ttrk[0] = sizik * ttrk[0] * rr1; + ttrk[1] = sizik * ttrk[1] * rr1; + ttrk[2] = sizik * ttrk[2] * rr1; + + // use energy switching if near the cutoff distance + + if (r2 > cut2) { + r3 = r2 * r; + r4 = r2 * r2; + r5 = r2 * r3; + taper = c5*r5 + c4*r4 + c3*r3 + c2*r2 + c1*r + c0; + dtaper = 5.0*c5*r4 + 4.0*c4*r3 + 3.0*c3*r2 + 2.0*c2*r + c1; + dtaper *= e * rr1; + e *= taper; + frcx = frcx*taper - dtaper*xr; + frcy = frcy*taper - dtaper*yr; + frcz = frcz*taper - dtaper*zr; + for (k = 0; k < 3; k++) { + ttri[k] *= taper; + ttrk[k] *= taper; + } + } + + erepulse += e; + + //fprintf(fp,"REPUL %d %d %15.12g %15.12g\n",atom->tag[i],atom->tag[j],r,e); + + // increment force-based gradient and torque on atom I + + frepulse[i][0] += frcx; + frepulse[i][1] += frcy; + frepulse[i][2] += frcz; + tq[i][0] += ttri[0]; + tq[i][1] += ttri[1]; + tq[i][2] += ttri[2]; + + // increment force-based gradient and torque on atom J + + frepulse[j][0] -= frcx; + frepulse[j][1] -= frcy; + frepulse[j][2] -= frcz; + tq[j][0] += ttrk[0]; + tq[j][1] += ttrk[1]; + tq[j][2] += ttrk[2]; + + // increment the virial due to pairwise Cartesian forces + + vxx = -xr * frcx; + vxy = -0.5 * (yr*frcx+xr*frcy); + vxz = -0.5 * (zr*frcx+xr*frcz); + vyy = -yr * frcy; + vyz = -0.5 * (zr*frcy+yr*frcz); + vzz = -zr * frcz; + + virrepulse[0] += vxx; + virrepulse[1] += vyy; + virrepulse[2] += vzz; + virrepulse[3] += vxy; + virrepulse[4] += vxz; + virrepulse[5] += vyz; + + // energy = e + // virial = 6-vec vir + // NOTE: add tally function + + if (evflag) { + } + } + } + + // DEBUG + //fclose(fp); + + // reverse comm to sum torque from ghost atoms to owned atoms + + crstyle = TORQUE; + comm->reverse_comm_pair(this); + + // resolve site torques then increment forces and virial + + for (i = 0; i < nlocal; i++) { + torque2force(i,tq[i],fix,fiy,fiz,frepulse); + + iz = zaxis2local[i]; + ix = xaxis2local[i]; + iy = yaxis2local[i]; + + xiz = x[iz][0] - x[i][0]; + yiz = x[iz][1] - x[i][1]; + ziz = x[iz][2] - x[i][2]; + xix = x[ix][0] - x[i][0]; + yix = x[ix][1] - x[i][1]; + zix = x[ix][2] - x[i][2]; + xiy = x[iy][0] - x[i][0]; + yiy = x[iy][1] - x[i][1]; + ziy = x[iy][2] - x[i][2]; + + vxx = xix*fix[0] + xiy*fiy[0] + xiz*fiz[0]; + vyy = yix*fix[1] + yiy*fiy[1] + yiz*fiz[1]; + vzz = zix*fix[2] + ziy*fiy[2] + ziz*fiz[2]; + vxy = 0.5 * (yix*fix[0] + yiy*fiy[0] + yiz*fiz[0] + + xix*fix[1] + xiy*fiy[1] + xiz*fiz[1]); + vxz = 0.5 * (zix*fix[0] + ziy*fiy[0] + ziz*fiz[0] + + xix*fix[2] + xiy*fiy[2] + xiz*fiz[2]); + vyz = 0.5 * (zix*fix[1] + ziy*fiy[1] + ziz*fiz[1] + + yix*fix[2] + yiy*fiy[2] + yiz*fiz[2]); + + virrepulse[0] += vxx; + virrepulse[1] += vyy; + virrepulse[2] += vzz; + virrepulse[3] += vxy; + virrepulse[4] += vxz; + virrepulse[5] += vyz; + + // virial = 6-vec vir + // NOTE: add tally function + + if (evflag) { + } + } +} + +/* ---------------------------------------------------------------------- + damprep generates coefficients for the Pauli repulsion + damping function for powers of the interatomic distance + + literature reference: + + J. A. Rackers and J. W. Ponder, "Classical Pauli Repulsion: An + Anisotropic, Atomic Multipole Model", Journal of Chemical Physics, + 150, 084104 (2019) +------------------------------------------------------------------------- */ + +void PairAmoeba::damprep(double r, double r2, double rr1, double rr3, + double rr5, double rr7, double rr9, double rr11, + int rorder, double dmpi, double dmpk, double *dmpik) +{ + double r3,r4; + double r5,r6,r7,r8; + double s,ds,d2s; + double d3s,d4s,d5s; + double dmpi2,dmpk2; + double dmpi22,dmpi23; + double dmpi24,dmpi25; + double dmpi26,dmpi27; + double dmpk22,dmpk23; + double dmpk24,dmpk25; + double dmpk26; + double eps,diff; + double expi,expk; + double dampi,dampk; + double pre,term,tmp; + + // compute tolerance value for damping exponents + + eps = 0.001; + diff = fabs(dmpi-dmpk); + + // treat the case where alpha damping exponents are equal + + if (diff < eps) { + r3 = r2 * r; + r4 = r3 * r; + r5 = r4 * r; + r6 = r5 * r; + r7 = r6 * r; + dmpi2 = 0.5 * dmpi; + dampi = dmpi2 * r; + expi = exp(-dampi); + dmpi22 = dmpi2 * dmpi2; + dmpi23 = dmpi22 * dmpi2; + dmpi24 = dmpi23 * dmpi2; + dmpi25 = dmpi24 * dmpi2; + dmpi26 = dmpi25 * dmpi2; + pre = 128.0; + s = (r + dmpi2*r2 + dmpi22*r3/3.0) * expi; + + ds = (dmpi22*r3 + dmpi23*r4) * expi / 3.0; + d2s = dmpi24 * expi * r5 / 9.0; + d3s = dmpi25 * expi * r6 / 45.0; + d4s = (dmpi25*r6 + dmpi26*r7) * expi / 315.0; + if (rorder >= 11) { + r8 = r7 * r; + dmpi27 = dmpi2 * dmpi26; + d5s = (dmpi25*r6 + dmpi26*r7 + dmpi27*r8/3.0) * expi / 945.0; + } + + // treat the case where alpha damping exponents are unequal + + } else { + r3 = r2 * r; + r4 = r3 * r; + r5 = r4 * r; + dmpi2 = 0.5 * dmpi; + dmpk2 = 0.5 * dmpk; + dampi = dmpi2 * r; + dampk = dmpk2 * r; + expi = exp(-dampi); + expk = exp(-dampk); + dmpi22 = dmpi2 * dmpi2; + dmpi23 = dmpi22 * dmpi2; + dmpi24 = dmpi23 * dmpi2; + dmpi25 = dmpi24 * dmpi2; + dmpk22 = dmpk2 * dmpk2; + dmpk23 = dmpk22 * dmpk2; + dmpk24 = dmpk23 * dmpk2; + dmpk25 = dmpk24 * dmpk2; + term = dmpi22 - dmpk22; + pre = 8192.0 * dmpi23 * dmpk23 / pow(term,4.0); + tmp = 4.0 * dmpi2 * dmpk2 / term; + s = (dampi-tmp)*expk + (dampk+tmp)*expi; + + ds = (dmpi2*dmpk2*r2 - 4.0*dmpi2*dmpk22*r/term - + 4.0*dmpi2*dmpk2/term) * expk + + (dmpi2*dmpk2*r2 + 4.0*dmpi22*dmpk2*r/term + 4.0*dmpi2*dmpk2/term) * expi; + d2s = (dmpi2*dmpk2*r2/3.0 + dmpi2*dmpk22*r3/3.0 - + (4.0/3.0)*dmpi2*dmpk23*r2/term - 4.0*dmpi2*dmpk22*r/term - + 4.0*dmpi2*dmpk2/term) * expk + + (dmpi2*dmpk2*r2/3.0 + dmpi22*dmpk2*r3/3.0 + + (4.0/3.0)*dmpi23*dmpk2*r2/term + 4.0*dmpi22*dmpk2*r/term + + 4.0*dmpi2*dmpk2/term) * expi; + d3s = (dmpi2*dmpk23*r4/15.0 + dmpi2*dmpk22*r3/5.0 + dmpi2*dmpk2*r2/5.0 - + (4.0/15.0)*dmpi2*dmpk24*r3/term - (8.0/5.0)*dmpi2*dmpk23*r2/term - + 4.0*dmpi2*dmpk22*r/term - 4.0/term*dmpi2*dmpk2) * expk + + (dmpi23*dmpk2*r4/15.0 + dmpi22*dmpk2*r3/5.0 + dmpi2*dmpk2*r2/5.0 + + (4.0/15.0)*dmpi24*dmpk2*r3/term + (8.0/5.0)*dmpi23*dmpk2*r2/term + + 4.0*dmpi22*dmpk2*r/term + 4.0/term*dmpi2*dmpk2) * expi; + d4s = (dmpi2*dmpk24*r5/105.0 + (2.0/35.0)*dmpi2*dmpk23*r4 + + dmpi2*dmpk22*r3/7.0 + dmpi2*dmpk2*r2/7.0 - + (4.0/105.0)*dmpi2*dmpk25*r4/term - (8.0/21.0)*dmpi2*dmpk24*r3/term - + (12.0/7.0)*dmpi2*dmpk23*r2/term - 4.0*dmpi2*dmpk22*r/term - + 4.0*dmpi2*dmpk2/term) * expk + + (dmpi24*dmpk2*r5/105.0 + (2.0/35.0)*dmpi23*dmpk2*r4 + + dmpi22*dmpk2*r3/7.0 + dmpi2*dmpk2*r2/7.0 + + (4.0/105.0)*dmpi25*dmpk2*r4/term + (8.0/21.0)*dmpi24*dmpk2*r3/term + + (12.0/7.0)*dmpi23*dmpk2*r2/term + 4.0*dmpi22*dmpk2*r/term + + 4.0*dmpi2*dmpk2/term) * expi; + + if (rorder >= 11) { + r6 = r5 * r; + dmpi26 = dmpi25 * dmpi2; + dmpk26 = dmpk25 * dmpk2; + d5s = (dmpi2*dmpk25*r6/945.0 + (2.0/189.0)*dmpi2*dmpk24*r5 + + dmpi2*dmpk23*r4/21.0 + dmpi2*dmpk22*r3/9.0 + dmpi2*dmpk2*r2/9.0 - + (4.0/945.0)*dmpi2*dmpk26*r5/term - + (4.0/63.0)*dmpi2*dmpk25*r4/term - (4.0/9.0)*dmpi2*dmpk24*r3/term - + (16.0/9.0)*dmpi2*dmpk23*r2/term - 4.0*dmpi2*dmpk22*r/term - + 4.0*dmpi2*dmpk2/term) * expk + + (dmpi25*dmpk2*r6/945.0 + (2.0/189.0)*dmpi24*dmpk2*r5 + + dmpi23*dmpk2*r4/21.0 + dmpi22*dmpk2*r3/9.0 + dmpi2*dmpk2*r2/9.0 + + (4.0/945.0)*dmpi26*dmpk2*r5/term + (4.0/63.0)*dmpi25*dmpk2*r4/term + + (4.0/9.0)*dmpi24*dmpk2*r3/term + (16.0/9.0)*dmpi23*dmpk2*r2/term + + 4.0*dmpi22*dmpk2*r/term + 4.0*dmpi2*dmpk2/term) * expi; + } + } + + // convert partial derivatives into full derivatives + + s = s * rr1; + ds = ds * rr3; + d2s = d2s * rr5; + d3s = d3s * rr7; + d4s = d4s * rr9; + d5s = d5s * rr11; + dmpik[0] = 0.5 * pre * s * s; + dmpik[2] = pre * s * ds; + dmpik[4] = pre * (s*d2s + ds*ds); + dmpik[6] = pre * (s*d3s + 3.0*ds*d2s); + dmpik[8] = pre * (s*d4s + 4.0*ds*d3s + 3.0*d2s*d2s); + if (rorder >= 11) dmpik[10] = pre * (s*d5s + 5.0*ds*d4s + 10.0*d2s*d3s); +} diff --git a/src/AMOEBA/amoeba_utils.cpp b/src/AMOEBA/amoeba_utils.cpp new file mode 100644 index 0000000000..ead7134ab6 --- /dev/null +++ b/src/AMOEBA/amoeba_utils.cpp @@ -0,0 +1,1249 @@ +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#include "pair_amoeba.h" +#include +#include "atom.h" +#include "domain.h" +#include "comm.h" +#include "neigh_list.h" +#include "fix_store.h" +#include "error.h" + +using namespace LAMMPS_NS; + +enum{NOFRAME,ZONLY,ZTHENX,BISECTOR,ZBISECT,THREEFOLD}; + +// ---------------------------------------------------------------------- +// utility methods used by different parts of the AMOEBA force field +// ---------------------------------------------------------------------- + +/* ---------------------------------------------------------------------- + kmpole performs one-time assignment of + xaxis,yaxis,zaxis multipole neighbors to each owned atom + sets polaxe and pole[13] multipole for each owned atom + NOTE: doesn't always do this identically to Tinker b/c atom order matters +------------------------------------------------------------------------- */ + +void PairAmoeba::kmpole() +{ + bool path; + int i,j,k,m,j12,k12,m12,k13,m13,flag; + int iframe,nframe; + int itype,jtype,ktype,mtype,xtype,ytype,ztype; + tagint jneigh,kneigh,mneigh; + + // DEBUG vectors + + tagint bondneigh[12]; + tagint angleneigh[36]; + + amtype = atom->ivector[index_amtype]; + xaxis = atom->ivector[index_xaxis]; + yaxis = atom->ivector[index_yaxis]; + zaxis = atom->ivector[index_zaxis]; + polaxe = atom->ivector[index_polaxe]; + + double **pole = fixpole->astore; + + int **nspecial = atom->nspecial; + int **special = atom->special; + int nlocal = atom->nlocal; + + int nmissing = 0; + + for (i = 0; i < nlocal; i++) { + itype = amtype[i]; + nframe = nmultiframe[itype]; + flag = 0; + + // DEBUG START + // create a sorted version of bond/angle neighs in special[][] + + //printf("BTAGS %d:",atom->tag[i]); + //for (j = 0; j < nspecial[i][0]; j++) printf(" %d",special[i][j]); + //printf("\n"); + + for (j = 0; j < nspecial[i][0]; j++) + bondneigh[j] = special[i][j]; + for (m = 0; m < nspecial[i][0]; m++) { + tagint smallest = MAXTAGINT; + for (j = m; j < nspecial[i][0]; j++) { + if (bondneigh[j] < smallest) { + smallest = bondneigh[j]; + k = j; + } + bondneigh[k] = bondneigh[m]; + bondneigh[m] = smallest; + } + } + + //printf(" %d:",atom->tag[i]); + //for (j = 0; j < nspecial[i][0]; j++) printf(" %d",bondneigh[j]); + //printf("\n"); + + //printf("ATAGS %d:",atom->tag[i]); + //for (j = nspecial[i][0]; j < nspecial[i][1]; j++) printf(" %d",special[i][j]); + //printf("\n"); + + for (j = nspecial[i][0]; j < nspecial[i][1]; j++) + angleneigh[j] = special[i][j]; + for (m = nspecial[i][0]; m < nspecial[i][1]; m++) { + tagint smallest = MAXTAGINT; + for (j = m; j < nspecial[i][1]; j++) { + if (angleneigh[j] < smallest) { + smallest = angleneigh[j]; + k = j; + } + angleneigh[k] = angleneigh[m]; + angleneigh[m] = smallest; + } + } + + //printf(" %d:",atom->tag[i]); + //for (j = nspecial[i][0]; j < nspecial[i][1]; j++) printf(" %d",angleneigh[j]); + //printf("\n"); + + // DEBUG STOP + + // assign xyz axis and fpole via only 1-2 connected atoms + + for (iframe = 0; iframe < nframe; iframe++) { + xtype = xpole[itype][iframe]; + ytype = ypole[itype][iframe]; + ztype = zpole[itype][iframe]; + for (j12 = 0; j12 < nspecial[i][0]; j12++) { + //jneigh = special[i][j12]; + jneigh = bondneigh[j12]; + j = atom->map(jneigh); + if (j < 0) + error->one(FLERR,"AMOEBA kmpole() could not find bond partner"); + jtype = amtype[j]; + if (jtype == ztype) { + for (k12 = 0; k12 < nspecial[i][0]; k12++) { + if (k12 == j12) continue; + //kneigh = special[i][k12]; + kneigh = bondneigh[k12]; + k = atom->map(kneigh); + if (k < 0) + error->one(FLERR,"AMOEBA kmpole() could not find bond partner"); + ktype = amtype[k]; + if (ktype == xtype) { + if (ytype == 0 && !flag) { // only match first time + //if (ytype == 0) { + flag = 1; + zaxis[i] = jneigh; + xaxis[i] = kneigh; + yaxis[i] = 0; + polaxe[i] = mpaxis[itype][iframe]; + for (j = 0; j < 13; j++) + pole[i][j] = fpole[itype][iframe][j]; + //if (nframe > 1) + //printf("KMPOLEA: id %d itype %d iframe %d nframe %d " + // "xyzaxis %d %d %d\n", + // atom->tag[i],itype,iframe+1,nframe, + // xaxis[i],yaxis[i],zaxis[i]); + } else { + for (m12 = 0; m12 < nspecial[i][0]; m12++) { + if (m12 == j12 || m12 == k12) continue; + //mneigh = special[i][m12]; + mneigh = bondneigh[m12]; + m = atom->map(mneigh); + if (m < 0) + error->one(FLERR,"AMOEBA kmpole() could not find bond partner"); + mtype = amtype[m]; + if (mtype == ytype && !flag) { + //if (mtype == ytype) { + flag = 1; + zaxis[i] = jneigh; + xaxis[i] = kneigh; + yaxis[i] = mneigh; + polaxe[i] = mpaxis[itype][iframe]; + for (j = 0; j < 13; j++) + pole[i][j] = fpole[itype][iframe][j]; + //if (nframe > 1) + //printf("KMPOLEB: id %d itype %d iframe %d nframe %d " + // "xyzaxis %d %d %d\n", + // atom->tag[i],itype,iframe+1,nframe, + // xaxis[i],yaxis[i],zaxis[i]); + } + } + } + } + } + } + } + } + + //if (atom->tag[i] == 68) printf("FLAG 68 %d: %d %d %d\n", + // flag,xaxis[i],yaxis[i],zaxis[i]); + + if (flag) continue; + + // assign xyz axis via 1-2 and 1-3 connected atoms + + for (iframe = 0; iframe < nframe; iframe++) { + xtype = xpole[itype][iframe]; + ytype = ypole[itype][iframe]; + ztype = zpole[itype][iframe]; + for (j12 = 0; j12 < nspecial[i][0]; j12++) { + //jneigh = special[i][j12]; + jneigh = bondneigh[j12]; + j = atom->map(jneigh); + if (j < 0) error->one(FLERR,"AMOEBA kmpole() could not find bond partner"); + jtype = amtype[j]; + if (jtype == ztype) { + for (k13 = nspecial[i][0]; k13 < nspecial[i][1]; k13++) { + //kneigh = special[i][k13]; + kneigh = angleneigh[k13]; + k = atom->map(kneigh); + if (k < 0) error->one(FLERR,"AMOEBA kmpole() could not find bond partner"); + ktype = amtype[k]; + path = false; + for (m12 = 0; m12 < nspecial[k][0]; m12++) + if (special[k][m12] == jneigh) path = true; + if (!path) continue; + + if (ktype == xtype) { + if (ytype == 0 && !flag) { + //if (ytype == 0) { + flag = 1; + zaxis[i] = jneigh; + xaxis[i] = kneigh; + yaxis[i] = 0; + polaxe[i] = mpaxis[itype][iframe]; + for (j = 0; j < 13; j++) + pole[i][j] = fpole[itype][iframe][j]; + //if (nframe > 1) + // printf("KMPOLEC: id %d itype %d iframe %d nframe %d " + // "xyzaxis %d %d %d\n", + // atom->tag[i],itype,iframe+1,nframe, + // xaxis[i],yaxis[i],zaxis[i]); + } else { + for (m13 = nspecial[i][0]; m13 < nspecial[i][1]; m13++) { + if (m13 == k13) continue; + //mneigh = special[i][m13]; + mneigh = angleneigh[m13]; + m = atom->map(mneigh); + if (m < 0) + error->one(FLERR,"AMOEBA kmpole() could not find bond partner"); + mtype = amtype[m]; + path = false; + for (m12 = 0; m12 < nspecial[m][0]; m12++) + if (special[m][m12] == jneigh) path = true; + if (!path) continue; + if (mtype == ytype && !flag) { + //if (mtype == ytype) { + flag = 1; + zaxis[i] = jneigh; + xaxis[i] = kneigh; + yaxis[i] = mneigh; + polaxe[i] = mpaxis[itype][iframe]; + for (j = 0; j < 13; j++) + pole[i][j] = fpole[itype][iframe][j]; + //if (nframe > 1) + //printf("KMPOLED: id %d itype %d iframe %d nframe %d " + // "xyzaxis %d %d %d\n", + // atom->tag[i],itype,iframe+1,nframe, + // xaxis[i],yaxis[i],zaxis[i]); + } + } + } + } + } + } + } + } + + if (flag) continue; + + // assign xyz axis via only a z-defining atom + + for (iframe = 0; iframe < nframe; iframe++) { + xtype = xpole[itype][iframe]; + ytype = ypole[itype][iframe]; + ztype = zpole[itype][iframe]; + for (j12 = 0; j12 < nspecial[i][0]; j12++) { + //jneigh = special[i][j12]; + jneigh = bondneigh[j12]; + j = atom->map(jneigh); + if (j < 0) error->one(FLERR,"AMOEBA kmpole() could not find bond partner"); + jtype = amtype[j]; + if (jtype == ztype) { + if (xtype == 0 && !flag) { + //if (xtype == 0) { + flag = 1; + zaxis[i] = jtype; + xaxis[i] = yaxis[i] = 0; + polaxe[i] = mpaxis[itype][iframe]; + for (j = 0; j < 13; j++) + pole[i][j] = fpole[itype][iframe][j]; + //if (nframe > 1) + //printf("KMPOLEE: id %d itype %d iframe %d nframe %d " + // "xyzaxis %d %d %d\n", + // atom->tag[i],itype,iframe+1,nframe, + // xaxis[i],yaxis[i],zaxis[i]); + } + } + } + } + + if (flag) continue; + + // assign xyz axis via no connected atoms + + for (iframe = 0; iframe < nframe; iframe++) { + xtype = xpole[itype][iframe]; + ytype = ypole[itype][iframe]; + ztype = zpole[itype][iframe]; + if (ztype == 0 && !flag) { + //if (ztype == 0) { + flag = 1; + zaxis[i] = xaxis[i] = yaxis[i] = 0; + polaxe[i] = mpaxis[itype][iframe]; + for (j = 0; j < 13; j++) + pole[i][j] = fpole[itype][iframe][j]; + //if (nframe > 1) + //printf("KMPOLEF: id %d itype %d iframe %d nframe %d " + // "xyzaxis %d %d %d\n", + // atom->tag[i],itype,iframe+1,nframe, + // xaxis[i],yaxis[i],zaxis[i]); + } + } + + if (flag) continue; + + // flag error if could not assign xyz axis + + nmissing++; + } + + // DEBUG + + /* + for (i = 0; i < nlocal; i++) + if (atom->tag[i] == 68) + printf("KMPOLE %d %d: %g %g %g %g: %g %g %g %g: %g %g %g %g: %g\n", + i,atom->tag[i], + pole[i][0],pole[i][1],pole[i][2],pole[i][3], + pole[i][4],pole[i][5],pole[i][6],pole[i][7], + pole[i][8],pole[i][9],pole[i][10],pole[i][11], + pole[i][12]); + */ + + // error check on missing settings + + int nmissing_all; + MPI_Allreduce(&nmissing,&nmissing_all,1,MPI_INT,MPI_SUM,world); + if (nmissing_all) { + char str[128]; + sprintf(str,"Pair amoeba multipole settings missing %d\n",nmissing_all); + error->all(FLERR,str); + } +} + +/* ---------------------------------------------------------------------- + chkpole inverts atomic multipole moments as necessary + at sites with chiral local reference frame definitions + called every timestep for each atom I +------------------------------------------------------------------------- */ + +void PairAmoeba::chkpole(int i) +{ + bool check; + int ia,ib,ic,id; + double xad,yad,zad; + double xbd,ybd,zbd; + double xcd,ycd,zcd; + double c1,c2,c3,vol; + + polaxe = atom->ivector[index_polaxe]; + double **pole = fixpole->astore; + + // test for chirality inversion + // if not, return + + check = true; + if (polaxe[i] != ZTHENX) check = false; + if (yaxis[i] == 0) check = false; + if (!check) return; + + ib = zaxis2local[i]; + ic = xaxis2local[i]; + id = yaxis2local[i]; + + // compute the signed parallelpiped volume at chiral site + + double **x = atom->x; + + xad = x[i][0] - x[id][0]; + yad = x[i][1] - x[id][1]; + zad = x[i][2] - x[id][2]; + xbd = x[ib][0] - x[id][0]; + ybd = x[ib][1] - x[id][1]; + zbd = x[ib][2] - x[id][2]; + xcd = x[ic][0] - x[id][0]; + ycd = x[ic][1] - x[id][1]; + zcd = x[ic][2] - x[id][2]; + c1 = ybd*zcd - zbd*ycd; + c2 = ycd*zad - zcd*yad; + c3 = yad*zbd - zad*ybd; + vol = xad*c1 + xbd*c2 + xcd*c3; + + // invert atomic multipole components involving the y-axis + // flip sign in permanent yaxis, not yaxis2local + + int k = yaxis[i]; + if ((k < 0 && vol > 0.0) || (k > 0 && vol < 0.0)) { + yaxis[i] = -k; + pole[i][2] = -pole[i][2]; + pole[i][5] = -pole[i][5]; + pole[i][7] = -pole[i][7]; + pole[i][9] = -pole[i][9]; + pole[i][11] = -pole[i][11]; + } + + // DEBUG + + /* + if (atom->tag[i] == 68) + printf("CHKPOLE %d %d: %g %g %g %g: %g %g %g %g: %g %g %g %g: %g\n", + i,atom->tag[i], + pole[i][0],pole[i][1],pole[i][2],pole[i][3], + pole[i][4],pole[i][5],pole[i][6],pole[i][7], + pole[i][8],pole[i][9],pole[i][10],pole[i][11], + pole[i][12]); + */ +} + +/* ---------------------------------------------------------------------- + rotmat finds the rotation matrix that rotates the local + coordinate system into the global frame at a multipole site + called every timestep for each atom I +------------------------------------------------------------------------- */ + +void PairAmoeba::rotmat(int i) +{ + int ii; + int ix,iy,iz; + double r,dot; + double xi,yi,zi; + double dx,dy,dz; + double dx1,dy1,dz1; + double dx2,dy2,dz2; + double dx3,dy3,dz3; + + polaxe = atom->ivector[index_polaxe]; + + // get coordinates and frame definition for the multipole site + + double **x = atom->x; + + xi = x[i][0]; + yi = x[i][1]; + zi = x[i][2]; + + iz = zaxis2local[i]; + ix = xaxis2local[i]; + iy = yaxis2local[i]; + + // use the identity matrix as the default rotation matrix + + rotate[0][0] = 1.0; + rotate[0][1] = 0.0; + rotate[0][2] = 0.0; + rotate[2][0] = 0.0; + rotate[2][1] = 0.0; + rotate[2][2] = 1.0; + + // z-only frame rotation matrix elements for z-axis only + + if (polaxe[i] == ZONLY) { + dx = x[iz][0] - xi; + dy = x[iz][1] - yi; + dz = x[iz][2] - zi; + r = sqrt(dx*dx + dy*dy + dz*dz); + rotate[2][0] = dx / r; + rotate[2][1] = dy / r; + rotate[2][2] = dz / r; + dx = 1.0; + dy = 0.0; + dz = 0.0; + dot = rotate[2][0]; + if (fabs(dot) > 0.866) { + dx = 0.0; + dy = 1.0; + dot = rotate[2][1]; + } + dx = dx - dot*rotate[2][0]; + dy = dy - dot*rotate[2][1]; + dz = dz - dot*rotate[2][2]; + r = sqrt(dx*dx + dy*dy + dz*dz); + rotate[0][0] = dx / r; + rotate[0][1] = dy / r; + rotate[0][2] = dz / r; + + // z-then-x frame rotation matrix elements for z- and x-axes + + } else if (polaxe[i] == ZTHENX) { + dx = x[iz][0] - xi; + dy = x[iz][1] - yi; + dz = x[iz][2] - zi; + r = sqrt(dx*dx + dy*dy + dz*dz); + rotate[2][0] = dx / r; + rotate[2][1] = dy / r; + rotate[2][2] = dz / r; + dx = x[ix][0] - xi; + dy = x[ix][1] - yi; + dz = x[ix][2] - zi; + dot = dx*rotate[2][0] + dy*rotate[2][1] + dz*rotate[2][2]; + dx = dx - dot*rotate[2][0]; + dy = dy - dot*rotate[2][1]; + dz = dz - dot*rotate[2][2]; + r = sqrt(dx*dx + dy*dy + dz*dz); + rotate[0][0] = dx / r; + rotate[0][1] = dy / r; + rotate[0][2] = dz / r; + + // bisector frame rotation matrix elements for z- and x-axes + + } else if (polaxe[i] == BISECTOR) { + dx = x[iz][0] - xi; + dy = x[iz][1] - yi; + dz = x[iz][2] - zi; + r = sqrt(dx*dx + dy*dy + dz*dz); + dx1 = dx / r; + dy1 = dy / r; + dz1 = dz / r; + dx = x[ix][0] - xi; + dy = x[ix][1] - yi; + dz = x[ix][2] - zi; + r = sqrt(dx*dx + dy*dy + dz*dz); + dx2 = dx / r; + dy2 = dy / r; + dz2 = dz / r; + dx = dx1 + dx2; + dy = dy1 + dy2; + dz = dz1 + dz2; + r = sqrt(dx*dx + dy*dy + dz*dz); + rotate[2][0] = dx / r; + rotate[2][1] = dy / r; + rotate[2][2] = dz / r; + dot = dx2*rotate[2][0] + dy2*rotate[2][1] + dz2*rotate[2][2]; + dx = dx2 - dot*rotate[2][0]; + dy = dy2 - dot*rotate[2][1]; + dz = dz2 - dot*rotate[2][2]; + r = sqrt(dx*dx + dy*dy + dz*dz); + rotate[0][0] = dx / r; + rotate[0][1] = dy / r; + rotate[0][2] = dz / r; + + // z-bisect frame rotation matrix elements for z- and x-axes + + } else if (polaxe[i] == ZBISECT) { + dx = x[iz][0] - xi; + dy = x[iz][1] - yi; + dz = x[iz][2] - zi; + r = sqrt(dx*dx + dy*dy + dz*dz); + rotate[2][0] = dx / r; + rotate[2][1] = dy / r; + rotate[2][2] = dz / r; + dx = x[ix][0] - xi; + dy = x[ix][1] - yi; + dz = x[ix][2] - zi; + r = sqrt(dx*dx + dy*dy + dz*dz); + dx1 = dx / r; + dy1 = dy / r; + dz1 = dz / r; + dx = x[iy][0] - xi; + dy = x[iy][1] - yi; + dz = x[iy][2] - zi; + r = sqrt(dx*dx + dy*dy + dz*dz); + dx2 = dx / r; + dy2 = dy / r; + dz2 = dz / r; + dx = dx1 + dx2; + dy = dy1 + dy2; + dz = dz1 + dz2; + r = sqrt(dx*dx + dy*dy + dz*dz); + dx = dx / r; + dy = dy / r; + dz = dz / r; + dot = dx*rotate[2][0] + dy*rotate[2][1] + dz*rotate[2][2]; + dx = dx - dot*rotate[2][0]; + dy = dy - dot*rotate[2][1]; + dz = dz - dot*rotate[2][2]; + r = sqrt(dx*dx + dy*dy + dz*dz); + rotate[0][0] = dx / r; + rotate[0][1] = dy / r; + rotate[0][2] = dz / r; + + // 3-fold frame rotation matrix elements for z- and x-axes + + } else if (polaxe[i] == THREEFOLD) { + dx = x[iz][0] - xi; + dy = x[iz][1] - yi; + dz = x[iz][2] - zi; + r = sqrt(dx*dx + dy*dy + dz*dz); + dx1 = dx / r; + dy1 = dy / r; + dz1 = dz / r; + dx = x[ix][0] - xi; + dy = x[ix][1] - yi; + dz = x[ix][2] - zi; + r = sqrt(dx*dx + dy*dy + dz*dz); + dx2 = dx / r; + dy2 = dy / r; + dz2 = dz / r; + dx = x[iy][0] - xi; + dy = x[iy][1] - yi; + dz = x[iy][2] - zi; + r = sqrt(dx*dx + dy*dy + dz*dz); + dx3 = dx / r; + dy3 = dy / r; + dz3 = dz / r; + dx = dx1 + dx2 + dx3; + dy = dy1 + dy2 + dy3; + dz = dz1 + dz2 + dz3; + r = sqrt(dx*dx + dy*dy + dz*dz); + rotate[2][0] = dx / r; + rotate[2][1] = dy / r; + rotate[2][2] = dz / r; + dot = dx2*rotate[2][0] + dy2*rotate[2][1] + dz2*rotate[2][2]; + dx = dx2 - dot*rotate[2][0]; + dy = dy2 - dot*rotate[2][1]; + dz = dz2 - dot*rotate[2][2]; + r = sqrt(dx*dx + dy*dy + dz*dz); + rotate[0][0] = dx / r; + rotate[0][1] = dy / r; + rotate[0][2] = dz / r; + } + + // finally, find rotation matrix elements for the y-axis + + rotate[1][0] = rotate[0][2]*rotate[2][1] - rotate[0][1]*rotate[2][2]; + rotate[1][1] = rotate[0][0]*rotate[2][2] - rotate[0][2]*rotate[2][0]; + rotate[1][2] = rotate[0][1]*rotate[2][0] - rotate[0][0]*rotate[2][1]; + + // DEBUG + + /* + if (atom->tag[i] == 68) + printf("ROTMAT %d %d: %d: %d %d %d: %d %d %d: %g %g %g: %g %g %g: %g %g %g\n", + i,atom->tag[i],polaxe[i],ix,iy,iz,atom->tag[ix],atom->tag[iy],atom->tag[iz], + rotate[0][0],rotate[0][1],rotate[0][2], + rotate[1][0],rotate[1][1],rotate[1][2], + rotate[2][0],rotate[2][1],rotate[2][2]); + */ +} + +/* ---------------------------------------------------------------------- + rotsite rotates the local frame atomic multipoles at a + specified site into the global coordinate frame by applying a rotation matrix + called every timestep for each atom Isite +------------------------------------------------------------------------- */ + +void PairAmoeba::rotsite(int isite) +{ + int i,j,k,m; + double mp[3][3]; + double rp[3][3]; + + double **pole = fixpole->astore; + + // monopoles have the same value in any coordinate frame + + rpole[isite][0] = pole[isite][0]; + + // rotate the dipoles to the global coordinate frame + + for (i = 1; i <= 3; i++) { + rpole[isite][i] = 0.0; + for (j = 1; j <= 3; j++) + rpole[isite][i] += pole[isite][j] * rotate[j-1][i-1]; + } + + // rotate the quadrupoles to the global coordinate frame + + k = 4; + for (i = 0; i < 3; i++) { + for (j = 0; j < 3; j++) { + mp[j][i] = pole[isite][k]; + rp[j][i] = 0.0; + k++; + } + } + + for (i = 0; i < 3; i++) { + for (j = 0; j < 3; j++) { + if (j < i) rp[j][i] = rp[i][j]; + else { + for (k = 0; k < 3; k++) + for (m = 0; m < 3; m++) + rp[j][i] += rotate[k][i]*rotate[m][j] * mp[m][k]; + } + } + } + + k = 4; + for (i = 0; i < 3; i++) { + for (j = 0; j < 3; j++) { + rpole[isite][k] = rp[j][i]; + k++; + } + } + + // DEBUG + + /* + i = isite; + if (atom->tag[i] == 68) + printf("ROTSITE %d %d: %g %g %g %g: %g %g %g %g: %g %g %g %g: %g\n", + i,atom->tag[i], + rpole[i][0],rpole[i][1],rpole[i][2],rpole[i][3], + rpole[i][4],rpole[i][5],rpole[i][6],rpole[i][7], + rpole[i][8],rpole[i][9],rpole[i][10],rpole[i][11], + rpole[i][12]); + */ +} + +/* ---------------------------------------------------------------------- + scan standard neighbor list and make it compatible with 1-5 neighbors + if IJ entry is a 1-2,1-3,1-4 neighbor then adjust offset to SBBITS15 + else scan special15 to see if a 1-5 neighbor and adjust offset to SBBITS15 + else do nothing to IJ entry +------------------------------------------------------------------------- */ + +void PairAmoeba::add_onefive_neighbors() +{ + int i,j,k,ii,jj,which,inum,jnum,n15; + tagint jtag; + int *ilist,*jlist,*numneigh,**firstneigh; + int *list15; + + // test for overflow of reduced allowed size of neighbor list + + if (atom->nlocal + atom->nghost > NEIGHMASK15) + error->one(FLERR,"Pair amoeba neighbor list overflow"); + + // neigh list + + inum = list->inum; + ilist = list->ilist; + numneigh = list->numneigh; + firstneigh = list->firstneigh; + + // reset special neighbor flags to include 1-5 neighbors + + tagint *tag = atom->tag; + int *nspecial15 = atom->nspecial15; + int **special15 = atom->special15; + + for (ii = 0; ii < inum; ii++) { + i = ilist[ii]; + n15 = nspecial15[i]; + list15 = special15[i]; + jlist = firstneigh[i]; + jnum = numneigh[i]; + + for (jj = 0; jj < jnum; jj++) { + j = jlist[jj]; + which = j >> SBBITS & 3; + j &= NEIGHMASK; + jtag = tag[j]; + + //if (atom->tag[i] == 1 && which) + // printf("ONEFIVE tags %d %d ij %d %d which %d jlist %d\n", + // atom->tag[i],atom->tag[j],i,j,which,jlist[jj]); + + if (!which) { + for (k = 0; k < n15; k++) { + if (list15[k] == jtag) { + which = 4; + break; + } + } + } + + if (which) jlist[jj] = j ^ (which << SBBITS15); + int newwhich = sbmask15(jlist[jj]); + + //if (atom->tag[i] == 1 && which) + // printf(" AFTER tags %d %d ij %d %d which %d jlist %d newwhich %d\n", + // atom->tag[i],atom->tag[j],i,j,which,jlist[jj],newwhich); + } + } +} + +/* ---------------------------------------------------------------------- + update local indices of hydrogen neighbors for owned and ghost atoms + ired2local = used for offset of hydrogen positions in Vdwl term + called on reneighboring steps, only for AMOEBA +------------------------------------------------------------------------- */ + +void PairAmoeba::find_hydrogen_neighbors() +{ + int index; + + // grab current ptr for ired + // ired[i] = atom ID that atom I is bonded to + // ired2local[i] = local index of that atom + // for furthest away ghost atoms, bond partner can be missing + // in that case ired2local = -1, but only an error if accessed in hal() + + ired = atom->ivector[index_ired]; + + int nlocal = atom->nlocal; + int nall = nlocal + atom->nghost; + int nmissing = 0; + + for (int i = 0; i < nall; i++) { + if (ired[i] == 0) ired2local[i] = i; + else { + index = atom->map(ired[i]); + if (index >= 0) index = domain->closest_image(i,index); + ired2local[i] = index; + } + } +} + +/* ---------------------------------------------------------------------- + update local indices of bond topology neighbors for owned atoms + xyz axis2local = used for multipole orientation + called on reneighboring steps +------------------------------------------------------------------------- */ + +void PairAmoeba::find_multipole_neighbors() +{ + int index; + + // grab current pts for xaxis,yaxis,zaxis + // xyz axis[i] = atom IDs that atom I uses for its multipole orientation + + xaxis = atom->ivector[index_xaxis]; + yaxis = atom->ivector[index_xaxis]; + zaxis = atom->ivector[index_zaxis]; + + int nlocal = atom->nlocal; + int nmissing = 0; + + // NOTE: are some of xyz axis not atom IDs, e.g. if has no bonds + + for (int i = 0; i < nlocal; i++) { + index = atom->map(xaxis[i]); + if (index == -1) nmissing++; + else { + index = domain->closest_image(i,index); + xaxis2local[i] = index; + } + + index = atom->map(yaxis[i]); + if (index == -1) nmissing++; + else { + index = domain->closest_image(i,index); + yaxis2local[i] = index; + } + + index = atom->map(zaxis[i]); + if (index == -1) nmissing++; + else { + index = domain->closest_image(i,index); + zaxis2local[i] = index; + } + } + + // error check on missing neighbors + + int nmissing_all; + MPI_Allreduce(&nmissing,&nmissing_all,1,MPI_INT,MPI_SUM,world); + if (nmissing_all) { + char str[128]; + sprintf(str,"Pair amoeba multipole neighbors missing %d\n",nmissing_all); + error->all(FLERR,str); + } +} + +/* ---------------------------------------------------------------------- + torque2force takes the torque values on a single site defined by + a local coordinate frame and converts to Cartesian forces on + the original site and sites specifying the local frame, also + gives the x,y,z-force components needed for virial computation + + force distribution for the 3-fold local frame by Chao Lu, + Ponder Lab, Washington University, July 2016 + + literature reference: + + P. L. Popelier and A. J. Stone, "Formulae for the First and + Second Derivatives of Anisotropic Potentials with Respect to + Geometrical Parameters", Molecular Physics, 82, 411-425 (1994) + + C. Segui, L. G. Pedersen and T. A. Darden, "Towards an Accurate + Representation of Electrostatics in Classical Force Fields: + Efficient Implementation of Multipolar Interactions in + Biomolecular Simulations", Journal of Chemical Physics, 120, + 73-87 (2004) + + i = single site = local atom index + trq = torque on that atom + frc xyz = returned xyz force components + f = force vector for local atoms, multiple atoms will be updated +------------------------------------------------------------------------- */ + +void PairAmoeba::torque2force(int i, double *trq, + double *frcx, double *frcy, double *frcz, + double **f) +{ + int j; + int ia,ib,ic,id; + int axetyp; + double du,dv,dw,dot; + double usiz,vsiz,wsiz; + double psiz,rsiz,ssiz; + double t1siz,t2siz; + double uvsiz,uwsiz,vwsiz; + double ursiz,ussiz; + double vssiz,wssiz; + double delsiz,dphiddel; + double uvcos,uwcos,urcos; + double vwcos,vscos,wscos; + double upcos,vpcos,wpcos; + double rwcos,rucos,rvcos; + double ut1cos,ut2cos; + double uvsin,uwsin,ursin; + double vwsin,vssin,wssin; + double rwsin,rusin,rvsin; + double ut1sin,ut2sin; + double dphidu,dphidv,dphidw; + double dphidr,dphids; + double u[3],v[3],w[3]; + double p[3],r[3],s[3]; + double t1[3],t2[3]; + double uv[3],uw[3],vw[3]; + double ur[3],us[3]; + double vs[3],ws[3]; + double del[3],eps[3]; + + double **x = atom->x; + + // zero out force components on local frame-defining atoms + + for (j = 0; j < 3; j++) { + frcz[j] = 0.0; + frcx[j] = 0.0; + frcy[j] = 0.0; + } + + // get the local frame type and the frame-defining atoms + + polaxe = atom->ivector[index_polaxe]; + axetyp = polaxe[i]; + if (axetyp == NOFRAME) return; + + ia = zaxis2local[i]; + ib = i; + ic = xaxis2local[i]; + id = yaxis2local[i]; + + // construct the three rotation axes for the local frame + + u[0] = x[ia][0] - x[ib][0]; + u[1] = x[ia][1] - x[ib][1]; + u[2] = x[ia][2] - x[ib][2]; + usiz = sqrt(u[0]*u[0] + u[1]*u[1] + u[2]*u[2]); + + if (axetyp != ZONLY) { + v[0] = x[ic][0] - x[ib][0]; + v[1] = x[ic][1] - x[ib][1]; + v[2] = x[ic][2] - x[ib][2]; + vsiz = sqrt(v[0]*v[0] + v[1]*v[1] + v[2]*v[2]); + } else { + v[0] = 1.0; + v[1] = 0.0; + v[2] = 0.0; + vsiz = 1.0; + dot = u[0] / usiz; + if (fabs(dot) > 0.866) { + v[0] = 0.0; + v[1] = 1.0; + } + } + + if (axetyp == ZBISECT || axetyp == THREEFOLD) { + w[0] = x[id][0] - x[ib][0]; + w[1] = x[id][1] - x[ib][1]; + w[2] = x[id][2] - x[ib][2]; + } else { + w[0] = u[1]*v[2] - u[2]*v[1]; + w[1] = u[2]*v[0] - u[0]*v[2]; + w[2] = u[0]*v[1] - u[1]*v[0]; + } + + wsiz = sqrt(w[0]*w[0] + w[1]*w[1] + w[2]*w[2]); + + for (j = 0; j < 3; j++) { + u[j] /= usiz; + v[j] /= vsiz; + w[j] /= wsiz; + } + + // build some additional axes needed for the Z-Bisect method + + if (axetyp == ZBISECT) { + r[0] = v[0] + w[0]; + r[1] = v[1] + w[1]; + r[2] = v[2] + w[2]; + rsiz = sqrt(r[0]*r[0] + r[1]*r[1] + r[2]*r[2]); + s[0] = u[1]*r[2] - u[2]*r[1]; + s[1] = u[2]*r[0] - u[0]*r[2]; + s[2] = u[0]*r[1] - u[1]*r[0]; + ssiz = sqrt(s[0]*s[0] + s[1]*s[1] + s[2]*s[2]); + for (j = 0; j < 3; j++) { + r[j] /= rsiz; + s[j] /= ssiz; + } + } + + // find the perpendicular and angle for each pair of axes + + uv[0] = v[1]*u[2] - v[2]*u[1]; + uv[1] = v[2]*u[0] - v[0]*u[2]; + uv[2] = v[0]*u[1] - v[1]*u[0]; + uvsiz = sqrt(uv[0]*uv[0] + uv[1]*uv[1] + uv[2]*uv[2]); + uw[0] = w[1]*u[2] - w[2]*u[1]; + uw[1] = w[2]*u[0] - w[0]*u[2]; + uw[2] = w[0]*u[1] - w[1]*u[0]; + uwsiz = sqrt(uw[0]*uw[0] + uw[1]*uw[1] + uw[2]*uw[2]); + vw[0] = w[1]*v[2] - w[2]*v[1]; + vw[1] = w[2]*v[0] - w[0]*v[2]; + vw[2] = w[0]*v[1] - w[1]*v[0]; + vwsiz = sqrt(vw[0]*vw[0] + vw[1]*vw[1] + vw[2]*vw[2]); + for (j = 0; j < 3; j++) { + uv[j] /= uvsiz; + uw[j] /= uwsiz; + vw[j] /= vwsiz; + } + + if (axetyp == ZBISECT) { + ur[0] = r[1]*u[2] - r[2]*u[1]; + ur[1] = r[2]*u[0] - r[0]*u[2]; + ur[2] = r[0]*u[1] - r[1]*u[0]; + ursiz = sqrt(ur[0]*ur[0] + ur[1]*ur[1] + ur[2]*ur[2]); + us[0] = s[1]*u[2] - s[2]*u[1]; + us[1] = s[2]*u[0] - s[0]*u[2]; + us[2] = s[0]*u[1] - s[1]*u[0]; + ussiz = sqrt(us[0]*us[0] + us[1]*us[1] + us[2]*us[2]); + vs[0] = s[1]*v[2] - s[2]*v[1]; + vs[1] = s[2]*v[0] - s[0]*v[2]; + vs[2] = s[0]*v[1] - s[1]*v[0]; + vssiz = sqrt(vs[0]*vs[0] + vs[1]*vs[1] + vs[2]*vs[2]); + ws[0] = s[1]*w[2] - s[2]*w[1]; + ws[1] = s[2]*w[0] - s[0]*w[2]; + ws[2] = s[0]*w[1] - s[1]*w[0]; + wssiz = sqrt(ws[0]*ws[0] + ws[1]*ws[1] + ws[2]*ws[2]); + for (j = 0; j < 3; j++) { + ur[j] /= ursiz; + us[j] /= ussiz; + vs[j] /= vssiz; + ws[j] /= wssiz; + } + } + + // get sine and cosine of angles between the rotation axes + + uvcos = u[0]*v[0] + u[1]*v[1] + u[2]*v[2]; + uvsin = sqrt(1.0 - uvcos*uvcos); + uwcos = u[0]*w[0] + u[1]*w[1] + u[2]*w[2]; + uwsin = sqrt(1.0 - uwcos*uwcos); + vwcos = v[0]*w[0] + v[1]*w[1] + v[2]*w[2]; + vwsin = sqrt(1.0 - vwcos*vwcos); + if (axetyp == ZBISECT) { + urcos = u[0]*r[0] + u[1]*r[1] + u[2]*r[2]; + ursin = sqrt(1.0 - urcos*urcos); + vscos = v[0]*s[0] + v[1]*s[1] + v[2]*s[2]; + vssin = sqrt(1.0 - vscos*vscos); + wscos = w[0]*s[0] + w[1]*s[1] + w[2]*s[2]; + wssin = sqrt(1.0 - wscos*wscos); + } + + // compute the projection of v and w onto the ru-plane + + if (axetyp == ZBISECT) { + for (j = 0; j < 3; j++) { + t1[j] = v[j] - s[j]*vscos; + t2[j] = w[j] - s[j]*wscos; + } + t1siz = sqrt(t1[0]*t1[0] + t1[1]*t1[1] + t1[2]*t1[2]); + t2siz = sqrt(t2[0]*t2[0] + t2[1]*t2[1] + t2[2]*t2[2]); + for (j = 0; j < 3; j++) { + t1[j] /= t1siz; + t2[j] /= t2siz; + } + ut1cos = u[0]*t1[0] + u[1]*t1[1] + u[2]*t1[2]; + ut1sin = sqrt(1.0 - ut1cos*ut1cos); + ut2cos = u[0]*t2[0] + u[1]*t2[1] + u[2]*t2[2]; + ut2sin = sqrt(1.0 - ut2cos*ut2cos); + } + + // negative of dot product of torque with unit vectors gives + // result of infinitesimal rotation along these vectors + + dphidu = -trq[0]*u[0] - trq[1]*u[1] - trq[2]*u[2]; + dphidv = -trq[0]*v[0] - trq[1]*v[1] - trq[2]*v[2]; + dphidw = -trq[0]*w[0] - trq[1]*w[1] - trq[2]*w[2]; + if (axetyp == ZBISECT) { + dphidr = -trq[0]*r[0] - trq[1]*r[1] - trq[2]*r[2]; + dphids = -trq[0]*s[0] - trq[1]*s[1] - trq[2]*s[2]; + } + + // force distribution for the Z-Only local coordinate method + + if (axetyp == ZONLY) { + for (j = 0; j < 3; j++) { + du = uv[j]*dphidv/(usiz*uvsin) + uw[j]*dphidw/usiz; + f[ia][j] += du; + f[ib][j] -= du; + frcz[j] += du; + } + + // force distribution for the Z-then-X local coordinate method + + } else if (axetyp == ZTHENX) { + for (j = 0; j < 3; j++) { + du = uv[j]*dphidv/(usiz*uvsin) + uw[j]*dphidw/usiz; + dv = -uv[j]*dphidu/(vsiz*uvsin); + f[ia][j] += du; + f[ic][j] += dv; + f[ib][j] -= du + dv; + frcz[j] += du; + frcx[j] += dv; + } + + // force distribution for the Bisector local coordinate method + + } else if (axetyp == BISECTOR) { + for (j = 0; j < 3; j++) { + du = uv[j]*dphidv/(usiz*uvsin) + 0.5*uw[j]*dphidw/usiz; + dv = -uv[j]*dphidu/(vsiz*uvsin) + 0.5*vw[j]*dphidw/vsiz; + f[ia][j] += du; + f[ic][j] += dv; + f[ib][j] -= du + dv; + frcz[j] += du; + frcx[j] += dv; + } + + // force distribution for the Z-Bisect local coordinate method + + } else if (axetyp == ZBISECT) { + for (j = 0; j < 3; j++) { + du = ur[j]*dphidr/(usiz*ursin) + us[j]*dphids/usiz; + dv = (vssin*s[j]-vscos*t1[j])*dphidu / (vsiz*(ut1sin+ut2sin)); + dw = (wssin*s[j]-wscos*t2[j])*dphidu / (wsiz*(ut1sin+ut2sin)); + f[ia][j] += du; + f[ic][j] += dv; + f[id][j] += dw; + f[ib][j] -= du + dv + dw; + frcz[j] += du; + frcx[j] += dv; + frcy[j] += dw; + } + + // force distribution for the 3-Fold local coordinate method + + } else if (axetyp == THREEFOLD) { + p[0] = u[0] + v[0] + w[0]; + p[1] = u[1] + v[1] + w[1]; + p[2] = u[2] + v[2] + w[2]; + psiz = sqrt(p[0]*p[0] + p[1]*p[1] + p[2]*p[2]) ; + for (j = 0; j < 3; j++) p[j] /= psiz; + + wpcos = w[0]*p[0] + w[1]*p[1] + w[2]*p[2]; + upcos = u[0]*p[0] + u[1]*p[1] + u[2]*p[2]; + vpcos = v[0]*p[0] + v[1]*p[1] + v[2]*p[2]; + r[0] = u[0] + v[0]; + r[1] = u[1] + v[1]; + r[2] = u[2] + v[2]; + rsiz = sqrt(r[0]*r[0] + r[1]*r[1] + r[2]*r[2]); + for (j = 0; j < 3; j++) r[j] /= rsiz; + + rwcos = r[0]*w[0] + r[1]*w[1] + r[2]*w[2]; + rwsin = sqrt(1.0 - rwcos*rwcos); + dphidr = -trq[0]*r[0] - trq[1]*r[1] - trq[2]*r[2]; + del[0] = r[1]*w[2] - r[2]*w[1]; + del[1] = r[2]*w[0] - r[0]*w[2] ; + del[2] = r[0]*w[1] - r[1]*w[0]; + delsiz = sqrt(del[0]*del[0] + del[1]*del[1] + del[2]*del[2]); + for (j = 0; j < 3; j++) del[j] /= delsiz; + + dphiddel = -trq[0]*del[0] - trq[1]*del[1] - trq[2]*del[2]; + eps[0] = del[1]*w[2] - del[2]*w[1]; + eps[1] = del[2]*w[0] - del[0]*w[2]; + eps[2] = del[0]*w[1] - del[1]*w[0]; + for (j = 0; j < 3; j++) { + dw = del[j]*dphidr/(wsiz*rwsin) + eps[j]*dphiddel*wpcos/(wsiz*psiz); + f[id][j] += dw; + f[ib][j] -= dw; + frcy[j] += dw; + } + r[0] = v[0] + w[0]; + r[1] = v[1] + w[1]; + r[2] = v[2] + w[2]; + rsiz = sqrt(r[0]*r[0] + r[1]*r[1] + r[2]*r[2]); + for (j = 0; j < 3; j++) r[j] /= rsiz; + + rucos = r[0]*u[0] + r[1]*u[1] + r[2]*u[2]; + rusin = sqrt(1.0 - rucos*rucos) ; + dphidr = -trq[0]*r[0] - trq[1]*r[1] - trq[2]*r[2]; + del[0] = r[1]*u[2] - r[2]*u[1]; + del[1] = r[2]*u[0] - r[0]*u[2]; + del[2] = r[0]*u[1] - r[1]*u[0]; + delsiz = sqrt(del[0]*del[0] + del[1]*del[1] + del[2]*del[2]); + for (j = 0; j < 3; j++) del[j] /= delsiz; + + dphiddel = -trq[0]*del[0] - trq[1]*del[1] - trq[2]*del[2]; + eps[0] = del[1]*u[2] - del[2]*u[1]; + eps[1] = del[2]*u[0] - del[0]*u[2]; + eps[2] = del[0]*u[1] - del[1]*u[0]; + for (j = 0; j < 3; j++) { + du = del[j]*dphidr/(usiz*rusin) + eps[j]*dphiddel*upcos/(usiz*psiz); + f[ia][j] += du; + f[ib][j] -= du; + frcz[j] += du; + } + r[0] = u[0] + w[0]; + r[1] = u[1] + w[1]; + r[2] = u[2] + w[2]; + rsiz = sqrt(r[0]*r[0] + r[1]*r[1] + r[2]*r[2]); + for (j = 0; j < 3; j++) r[j] /= rsiz; + + rvcos = r[0]*v[0] + r[1]*v[1] + r[2]*v[2] ; + rvsin = sqrt(1.0 - rvcos*rvcos); + dphidr = -trq[0]*r[0] - trq[1]*r[1] - trq[2]*r[2]; + del[0] = r[1]*v[2] - r[2]*v[1]; + del[1] = r[2]*v[0] - r[0]*v[2]; + del[2] = r[0]*v[1] - r[1]*v[0]; + delsiz = sqrt(del[0]*del[0] + del[1]*del[1] + del[2]*del[2]); + for (j = 0; j < 3; j++) del[j] /= delsiz; + + dphiddel = -trq[0]*del[0] - trq[1]*del[1] - trq[2]*del[2]; + eps[0] = del[1]*v[2] - del[2]*v[1]; + eps[1] = del[2]*v[0] - del[0]*v[2]; + eps[2] = del[0]*v[1] - del[1]*v[0]; + for (j = 0; j < 3; j++) { + dv = del[j]*dphidr/(vsiz*rvsin) + eps[j]*dphiddel*vpcos/(vsiz*psiz); + f[ic][j] += dv; + f[ib][j] -= dv; + frcx[j] += dv; + } + } +} diff --git a/src/AMOEBA/angle_amoeba.cpp b/src/AMOEBA/angle_amoeba.cpp new file mode 100644 index 0000000000..a82f390a84 --- /dev/null +++ b/src/AMOEBA/angle_amoeba.cpp @@ -0,0 +1,535 @@ +// clang-format off +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + https://www.lammps.org/, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#include "angle_amoeba.h" + +#include +#include +#include "atom.h" +#include "neighbor.h" +#include "domain.h" +#include "comm.h" +#include "force.h" +#include "math_const.h" +#include "memory.h" +#include "error.h" + +using namespace LAMMPS_NS; +using namespace MathConst; + +#define SMALL 0.001 + +/* ---------------------------------------------------------------------- */ + +AngleAmoeba::AngleAmoeba(LAMMPS *lmp) : Angle(lmp) +{ + pflag = nullptr; + theta0 = nullptr; + k2 = nullptr; + k3 = nullptr; + k4 = nullptr; + k5 = nullptr; + k6 = nullptr; +} + +/* ---------------------------------------------------------------------- */ + +AngleAmoeba::~AngleAmoeba() +{ + if (copymode) return; + + if (allocated) { + memory->destroy(setflag); + + memory->destroy(pflag); + memory->destroy(theta0); + memory->destroy(k2); + memory->destroy(k3); + memory->destroy(k4); + memory->destroy(k5); + memory->destroy(k6); + } +} + +/* ---------------------------------------------------------------------- */ + +void AngleAmoeba::compute(int eflag, int vflag) +{ + int i1,i2,i3,n,type,tflag; + double delx1,dely1,delz1,delx2,dely2,delz2; + double eangle,f1[3],f3[3]; + double dtheta,dtheta2,dtheta3,dtheta4,dtheta5,dtheta6,de_angle; + double dr1,dr2,tk1,tk2,aa1,aa2,aa11,aa12,aa21,aa22; + double rsq1,rsq2,r1,r2,c,s,a,a11,a12,a22,b1,b2; + + eangle = 0.0; + ev_init(eflag,vflag); + + double **x = atom->x; + double **f = atom->f; + int **anglelist = neighbor->anglelist; + int nanglelist = neighbor->nanglelist; + int nlocal = atom->nlocal; + int newton_bond = force->newton_bond; + + for (n = 0; n < nanglelist; n++) { + i1 = anglelist[n][0]; + i2 = anglelist[n][1]; + i3 = anglelist[n][2]; + type = anglelist[n][3]; + + // tflag = 0 for "angle", 1 for "anglep" in Tinker PRM file + // atom 2 must have 3 bond partners to invoke "anglep" option + + tflag = pflag[type]; + + if (tflag && atom->num_bond[i2] == 3) { + anglep(i1,i2,i3,type,eflag); + continue; + } + + // 1st bond + + delx1 = x[i1][0] - x[i2][0]; + dely1 = x[i1][1] - x[i2][1]; + delz1 = x[i1][2] - x[i2][2]; + + rsq1 = delx1*delx1 + dely1*dely1 + delz1*delz1; + r1 = sqrt(rsq1); + + // 2nd bond + + delx2 = x[i3][0] - x[i2][0]; + dely2 = x[i3][1] - x[i2][1]; + delz2 = x[i3][2] - x[i2][2]; + + rsq2 = delx2*delx2 + dely2*dely2 + delz2*delz2; + r2 = sqrt(rsq2); + + // angle (cos and sin) + + c = delx1*delx2 + dely1*dely2 + delz1*delz2; + c /= r1*r2; + + if (c > 1.0) c = 1.0; + if (c < -1.0) c = -1.0; + + s = sqrt(1.0 - c*c); + if (s < SMALL) s = SMALL; + s = 1.0/s; + + // force & energy for angle term + + dtheta = acos(c) - theta0[type]; + dtheta2 = dtheta*dtheta; + dtheta3 = dtheta2*dtheta; + dtheta4 = dtheta3*dtheta; + dtheta5 = dtheta4*dtheta; + dtheta6 = dtheta5*dtheta; + + de_angle = 2.0*k2[type]*dtheta + 3.0*k3[type]*dtheta2 + + 4.0*k4[type]*dtheta3 + 5.0*k5[type]*dtheta4 + 6.0*k6[type]*dtheta5; + + a = -de_angle*s; + a11 = a*c / rsq1; + a12 = -a / (r1*r2); + a22 = a*c / rsq2; + + f1[0] = a11*delx1 + a12*delx2; + f1[1] = a11*dely1 + a12*dely2; + f1[2] = a11*delz1 + a12*delz2; + + f3[0] = a22*delx2 + a12*delx1; + f3[1] = a22*dely2 + a12*dely1; + f3[2] = a22*delz2 + a12*delz1; + + if (eflag) eangle = k2[type]*dtheta2 + k3[type]*dtheta3 + + k4[type]*dtheta4 + k5[type]*dtheta5 + k6[type]*dtheta6; + + // apply force to each of 3 atoms + + if (newton_bond || i1 < nlocal) { + f[i1][0] += f1[0]; + f[i1][1] += f1[1]; + f[i1][2] += f1[2]; + } + + if (newton_bond || i2 < nlocal) { + f[i2][0] -= f1[0] + f3[0]; + f[i2][1] -= f1[1] + f3[1]; + f[i2][2] -= f1[2] + f3[2]; + } + + if (newton_bond || i3 < nlocal) { + f[i3][0] += f3[0]; + f[i3][1] += f3[1]; + f[i3][2] += f3[2]; + } + + if (evflag) ev_tally(i1,i2,i3,nlocal,newton_bond,eangle,f1,f3, + delx1,dely1,delz1,delx2,dely2,delz2); + } +} + +/* ---------------------------------------------------------------------- */ + +void AngleAmoeba::anglep(int i1, int i2, int i3, int type, int eflag) +{ + int i4; + tagint i1tag,i3tag,i4tag; + double xia,yia,zia,xib,yib,zib,xic,yic,zic,xid,yid,zid; + double xad,yad,zad,xbd,ybd,zbd,xcd,ycd,zcd; + double xt,yt,zt,rt2; + double xip,yip,zip,xap,yap,zap,xcp,ycp,zcp; + double rap2,rcp2; + double dtheta,dtheta2,dtheta3,dtheta4,dtheta5,dtheta6; + double xm,ym,zm,rm,dot; + double cosine,angle; + double eangle,deddt; + double dedxip,dedyip,dedzip,dpdxia,dpdyia,dpdzia,dpdxic,dpdyic,dpdzic; + double delta,delta2,ptrt2,term,terma,termc; + double f1[3],f2[3],f3[3],f4[3]; + + double **x = atom->x; + double **f = atom->f; + tagint **bond_atom = atom->bond_atom; + int nlocal = atom->nlocal; + int newton_bond = force->newton_bond; + + // i4 = index of third atom that i2 is bonded to + + i1tag = atom->tag[i1]; + i3tag = atom->tag[i3]; + + for (int ibond = 0; ibond < 3; ibond++) { + i4tag = bond_atom[i2][ibond]; + if (i4tag != i1tag && i4tag != i3tag) break; + } + + i4 = atom->map(i4tag); + i4 = domain->closest_image(i2,i4); + + // anglep out-of-plane calculation from Tinker + + xia = x[i1][0]; + yia = x[i1][1]; + zia = x[i1][2]; + xib = x[i2][0]; + yib = x[i2][1]; + zib = x[i2][2]; + xic = x[i3][0]; + yic = x[i3][1]; + zic = x[i3][2]; + xid = x[i4][0]; + yid = x[i4][1]; + zid = x[i4][2]; + + xad = xia - xid; + yad = yia - yid; + zad = zia - zid; + xbd = xib - xid; + ybd = yib - yid; + zbd = zib - zid; + xcd = xic - xid; + ycd = yic - yid; + zcd = zic - zid; + + xt = yad*zcd - zad*ycd; + yt = zad*xcd - xad*zcd; + zt = xad*ycd - yad*xcd; + rt2 = xt*xt + yt*yt + zt*zt; + delta = -(xt*xbd + yt*ybd + zt*zbd) / rt2; + xip = xib + xt*delta; + yip = yib + yt*delta; + zip = zib + zt*delta; + xap = xia - xip; + yap = yia - yip; + zap = zia - zip; + xcp = xic - xip; + ycp = yic - yip; + zcp = zic - zip; + rap2 = xap*xap + yap*yap + zap*zap; + rcp2 = xcp*xcp + ycp*ycp + zcp*zcp; + + // NOTE: can these be 0.0 ? what to do? + + if (rap2 == 0.0 || rcp2 == 0.0) return; + + xm = ycp*zap - zcp*yap; + ym = zcp*xap - xcp*zap; + zm = xcp*yap - ycp*xap; + rm = sqrt(xm*xm + ym*ym + zm*zm); + rm = MAX(rm,0.0001); + dot = xap*xcp + yap*ycp + zap*zcp; + cosine = dot / sqrt(rap2*rcp2); + cosine = MIN(1.0,MAX(-1.0,cosine)); + + // force & energy for angle term + + dtheta = acos(cosine) - theta0[type]; + dtheta2 = dtheta*dtheta; + dtheta3 = dtheta2*dtheta; + dtheta4 = dtheta3*dtheta; + dtheta5 = dtheta4*dtheta; + dtheta6 = dtheta5*dtheta; + + deddt = 2.0*k2[type]*dtheta + 3.0*k3[type]*dtheta2 + + 4.0*k4[type]*dtheta3 + 5.0*k5[type]*dtheta4 + 6.0*k6[type]*dtheta5; + + if (eflag) eangle = k2[type]*dtheta2 + k3[type]*dtheta3 + + k4[type]*dtheta4 + k5[type]*dtheta5 + k6[type]*dtheta6; + + printf("ANGLEP: %d %d %d %d: eng %g\n", + atom->tag[i1], + atom->tag[i2], + atom->tag[i3], + atom->tag[i4], + eangle); + + // chain rule terms for first derivative components + + terma = -deddt / (rap2*rm); + termc = deddt / (rcp2*rm); + f1[0] = terma * (yap*zm-zap*ym); + f1[1] = terma * (zap*xm-xap*zm); + f1[2] = terma * (xap*ym-yap*xm); + f3[0] = termc * (ycp*zm-zcp*ym); + f3[1] = termc * (zcp*xm-xcp*zm); + f3[2] = termc * (xcp*ym-ycp*xm); + dedxip = -f1[0] - f3[0]; + dedyip = -f1[1] - f3[1]; + dedzip = -f1[2] - f3[2]; + + // chain rule components for the projection of the central atom + + delta2 = 2.0 * delta; + ptrt2 = (dedxip*xt + dedyip*yt + dedzip*zt) / rt2; + term = (zcd*ybd-ycd*zbd) + delta2*(yt*zcd-zt*ycd); + dpdxia = delta*(ycd*dedzip-zcd*dedyip) + term*ptrt2; + term = (xcd*zbd-zcd*xbd) + delta2*(zt*xcd-xt*zcd); + dpdyia = delta*(zcd*dedxip-xcd*dedzip) + term*ptrt2; + term = (ycd*xbd-xcd*ybd) + delta2*(xt*ycd-yt*xcd); + dpdzia = delta*(xcd*dedyip-ycd*dedxip) + term*ptrt2; + term = (yad*zbd-zad*ybd) + delta2*(zt*yad-yt*zad); + dpdxic = delta*(zad*dedyip-yad*dedzip) + term*ptrt2; + term = (zad*xbd-xad*zbd) + delta2*(xt*zad-zt*xad); + dpdyic = delta*(xad*dedzip-zad*dedxip) + term*ptrt2; + term = (xad*ybd-yad*xbd) + delta2*(yt*xad-xt*yad); + dpdzic = delta*(yad*dedxip-xad*dedyip) + term*ptrt2; + + // compute derivative components for this interaction + + f1[0] += dpdxia; + f1[1] += dpdyia; + f1[2] += dpdzia; + f2[0] = dedxip; + f2[1] = dedyip; + f2[2] = dedzip; + f3[0] += dpdxic; + f3[1] += dpdyic; + f3[2] += dpdzic; + f4[0] = -f1[0] - f2[0] - f3[0]; + f4[1] = -f1[1] - f2[1] - f3[1]; + f4[2] = -f1[2] - f2[2] - f3[2]; + + // apply force to each of 4 atoms + + if (newton_bond || i1 < nlocal) { + f[i1][0] += f1[0]; + f[i1][1] += f1[1]; + f[i1][2] += f1[2]; + } + + if (newton_bond || i2 < nlocal) { + f[i2][0] += f2[0]; + f[i2][1] += f2[1]; + f[i2][2] += f2[2]; + } + + if (newton_bond || i3 < nlocal) { + f[i3][0] += f3[0]; + f[i3][1] += f3[1]; + f[i3][2] += f3[2]; + } + + if (newton_bond || i4 < nlocal) { + f[i4][0] += f4[0]; + f[i4][1] += f4[1]; + f[i4][2] += f4[2]; + } + + if (evflag) ev_tally4(i1,i2,i3,14,nlocal,newton_bond,eangle,f1,f2,f3,f4); +} + +/* ---------------------------------------------------------------------- */ + +void AngleAmoeba::allocate() +{ + allocated = 1; + int n = atom->nangletypes; + + memory->create(pflag,n+1,"angle:pflag"); + memory->create(theta0,n+1,"angle:theta0"); + memory->create(k2,n+1,"angle:k2"); + memory->create(k3,n+1,"angle:k3"); + memory->create(k4,n+1,"angle:k4"); + memory->create(k5,n+1,"angle:k5"); + memory->create(k6,n+1,"angle:k6"); + + memory->create(setflag,n+1,"angle:setflag"); + for (int i = 1; i <= n; i++) setflag[i] = 0; +} + +/* ---------------------------------------------------------------------- + set coeffs for one or more types +------------------------------------------------------------------------- */ + +void AngleAmoeba::coeff(int narg, char **arg) +{ + if (!allocated) allocate(); + + int ilo,ihi; + utils::bounds(FLERR,arg[0],1,atom->nangletypes,ilo,ihi,error); + + int count = 0; + + if (narg != 8) error->all(FLERR,"Incorrect args for angle coefficients"); + + int pflag_one = utils::inumeric(FLERR,arg[1],false,lmp); + double theta0_one = utils::numeric(FLERR,arg[2],false,lmp); + double k2_one = utils::numeric(FLERR,arg[3],false,lmp); + double k3_one = utils::numeric(FLERR,arg[4],false,lmp); + double k4_one = utils::numeric(FLERR,arg[5],false,lmp); + double k5_one = utils::numeric(FLERR,arg[6],false,lmp); + double k6_one = utils::numeric(FLERR,arg[7],false,lmp); + + // convert theta0 from degrees to radians + + for (int i = ilo; i <= ihi; i++) { + pflag[i] = pflag_one; + theta0[i] = theta0_one/180.0 * MY_PI; + k2[i] = k2_one; + k3[i] = k3_one; + k4[i] = k4_one; + k5[i] = k5_one; + k6[i] = k6_one; + count++; + } + + if (count == 0) error->all(FLERR,"Incorrect args for angle coefficients"); + + for (int i = ilo; i <= ihi; i++) setflag[i] = 1; +} + +/* ---------------------------------------------------------------------- */ + +double AngleAmoeba::equilibrium_angle(int i) +{ + return theta0[i]; +} + +/* ---------------------------------------------------------------------- + proc 0 writes out coeffs to restart file +------------------------------------------------------------------------- */ + +void AngleAmoeba::write_restart(FILE *fp) +{ + fwrite(&pflag[1],sizeof(int),atom->nangletypes,fp); + fwrite(&theta0[1],sizeof(double),atom->nangletypes,fp); + fwrite(&k2[1],sizeof(double),atom->nangletypes,fp); + fwrite(&k3[1],sizeof(double),atom->nangletypes,fp); + fwrite(&k4[1],sizeof(double),atom->nangletypes,fp); + fwrite(&k5[1],sizeof(double),atom->nangletypes,fp); + fwrite(&k6[1],sizeof(double),atom->nangletypes,fp); +} + +/* ---------------------------------------------------------------------- + proc 0 reads coeffs from restart file, bcasts them +------------------------------------------------------------------------- */ + +void AngleAmoeba::read_restart(FILE *fp) +{ + allocate(); + + if (comm->me == 0) { + utils::sfread(FLERR,&pflag[1],sizeof(int),atom->nangletypes,fp,nullptr,error); + utils::sfread(FLERR,&theta0[1],sizeof(double),atom->nangletypes,fp,nullptr,error); + utils::sfread(FLERR,&k2[1],sizeof(double),atom->nangletypes,fp,nullptr,error); + utils::sfread(FLERR,&k3[1],sizeof(double),atom->nangletypes,fp,nullptr,error); + utils::sfread(FLERR,&k4[1],sizeof(double),atom->nangletypes,fp,nullptr,error); + utils::sfread(FLERR,&k5[1],sizeof(double),atom->nangletypes,fp,nullptr,error); + utils::sfread(FLERR,&k6[1],sizeof(double),atom->nangletypes,fp,nullptr,error); + } + + MPI_Bcast(&pflag[1],atom->nangletypes,MPI_INT,0,world); + MPI_Bcast(&theta0[1],atom->nangletypes,MPI_DOUBLE,0,world); + MPI_Bcast(&k2[1],atom->nangletypes,MPI_DOUBLE,0,world); + MPI_Bcast(&k3[1],atom->nangletypes,MPI_DOUBLE,0,world); + MPI_Bcast(&k4[1],atom->nangletypes,MPI_DOUBLE,0,world); + MPI_Bcast(&k5[1],atom->nangletypes,MPI_DOUBLE,0,world); + MPI_Bcast(&k6[1],atom->nangletypes,MPI_DOUBLE,0,world); + + for (int i = 1; i <= atom->nangletypes; i++) setflag[i] = 1; +} + +/* ---------------------------------------------------------------------- + proc 0 writes to data file +------------------------------------------------------------------------- */ + +void AngleAmoeba::write_data(FILE *fp) +{ + for (int i = 1; i <= atom->nangletypes; i++) + fprintf(fp,"%d %d %g %g %g %g %g %g\n", + i,pflag[i],theta0[i]/MY_PI*180.0,k2[i],k3[i],k4[i],k5[i],k6[i]); +} + +/* ---------------------------------------------------------------------- */ + +double AngleAmoeba::single(int type, int i1, int i2, int i3) +{ + double **x = atom->x; + + double delx1 = x[i1][0] - x[i2][0]; + double dely1 = x[i1][1] - x[i2][1]; + double delz1 = x[i1][2] - x[i2][2]; + domain->minimum_image(delx1,dely1,delz1); + double r1 = sqrt(delx1*delx1 + dely1*dely1 + delz1*delz1); + + double delx2 = x[i3][0] - x[i2][0]; + double dely2 = x[i3][1] - x[i2][1]; + double delz2 = x[i3][2] - x[i2][2]; + domain->minimum_image(delx2,dely2,delz2); + double r2 = sqrt(delx2*delx2 + dely2*dely2 + delz2*delz2); + + double c = delx1*delx2 + dely1*dely2 + delz1*delz2; + c /= r1*r2; + if (c > 1.0) c = 1.0; + if (c < -1.0) c = -1.0; + + double s = sqrt(1.0 - c*c); + if (s < SMALL) s = SMALL; + s = 1.0/s; + + double dtheta = acos(c) - theta0[type]; + double dtheta2 = dtheta*dtheta; + double dtheta3 = dtheta2*dtheta; + double dtheta4 = dtheta3*dtheta; + double dtheta5 = dtheta4*dtheta; + double dtheta6 = dtheta5*dtheta; + + double energy = k2[type]*dtheta2 + k3[type]*dtheta3 + k4[type]*dtheta4 + + k5[type]*dtheta5 + k6[type]*dtheta6; + + return energy; +} diff --git a/src/AMOEBA/angle_amoeba.h b/src/AMOEBA/angle_amoeba.h new file mode 100644 index 0000000000..66a0c2c6b7 --- /dev/null +++ b/src/AMOEBA/angle_amoeba.h @@ -0,0 +1,58 @@ +/* -*- c++ -*- ---------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + https://www.lammps.org/, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#ifdef ANGLE_CLASS +// clang-format off +AngleStyle(amoeba,AngleAmoeba); +// clang-format on +#else + +#ifndef LMP_ANGLE_AMOEBA_H +#define LMP_ANGLE_AMOEBA_H + +#include "angle.h" + +namespace LAMMPS_NS { + +class AngleAmoeba : public Angle { + public: + AngleAmoeba(class LAMMPS *); + virtual ~AngleAmoeba(); + void compute(int, int); + void coeff(int, char **); + double equilibrium_angle(int); + void write_restart(FILE *); + void read_restart(FILE *); + void write_data(FILE *); + double single(int, int, int, int); + + protected: + int *pflag; + double *theta0, *k2, *k3, *k4, *k5, *k6; + + void anglep(int, int, int, int, int); + void allocate(); +}; + +} // namespace LAMMPS_NS + +#endif +#endif + +/* ERROR/WARNING messages: + +E: Incorrect args for angle coefficients + +Self-explanatory. Check the input script or data file. + +*/ diff --git a/src/AMOEBA/atom_vec_amoeba.cpp b/src/AMOEBA/atom_vec_amoeba.cpp new file mode 100644 index 0000000000..3bb77ac214 --- /dev/null +++ b/src/AMOEBA/atom_vec_amoeba.cpp @@ -0,0 +1,237 @@ +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#include "atom_vec_amoeba.h" +#include "atom.h" + +using namespace LAMMPS_NS; + +/* ---------------------------------------------------------------------- */ + +AtomVecAmoeba::AtomVecAmoeba(LAMMPS *lmp) : AtomVec(lmp) +{ + molecular = 1; + bonds_allow = angles_allow = dihedrals_allow = impropers_allow = 1; + mass_type = 1; + + atom->molecule_flag = atom->q_flag = 1; + atom->nspecial15_flag = 1; + + // strings with peratom variables to include in each AtomVec method + // strings cannot contain fields in corresponding AtomVec default strings + // order of fields in a string does not matter + // except: fields_data_atom & fields_data_vel must match data file + + fields_grow = (char *) + "q molecule num_bond bond_type bond_atom " + "num_angle angle_type angle_atom1 angle_atom2 angle_atom3 " + "num_dihedral dihedral_type dihedral_atom1 dihedral_atom2 " + "dihedral_atom3 dihedral_atom4 " + "num_improper improper_type improper_atom1 improper_atom2 " + "improper_atom3 improper_atom4 " + "nspecial special nspecial15 special15"; + fields_copy = (char *) + "q molecule num_bond bond_type bond_atom " + "num_angle angle_type angle_atom1 angle_atom2 angle_atom3 " + "num_dihedral dihedral_type dihedral_atom1 dihedral_atom2 " + "dihedral_atom3 dihedral_atom4 " + "num_improper improper_type improper_atom1 improper_atom2 " + "improper_atom3 improper_atom4 " + "nspecial special nspecial15 special15"; + fields_comm = (char *) ""; + fields_comm_vel = (char *) ""; + fields_reverse = (char *) ""; + fields_border = (char *) "q molecule"; + fields_border_vel = (char *) "q molecule"; + fields_exchange = (char *) + "q molecule num_bond bond_type bond_atom " + "num_angle angle_type angle_atom1 angle_atom2 angle_atom3 " + "num_dihedral dihedral_type dihedral_atom1 dihedral_atom2 " + "dihedral_atom3 dihedral_atom4 " + "num_improper improper_type improper_atom1 improper_atom2 " + "improper_atom3 improper_atom4 " + "nspecial special nspecial15 special15"; + fields_restart = (char *) + "q molecule num_bond bond_type bond_atom " + "num_angle angle_type angle_atom1 angle_atom2 angle_atom3 " + "num_dihedral dihedral_type dihedral_atom1 dihedral_atom2 " + "dihedral_atom3 dihedral_atom4 " + "num_improper improper_type improper_atom1 improper_atom2 " + "improper_atom3 improper_atom4"; + fields_create = (char *) + "q molecule num_bond num_angle num_dihedral num_improper nspecial nspecial15"; + fields_data_atom = (char *) "id molecule type q x"; + fields_data_vel = (char *) "id v"; + + setup_fields(); + + bond_per_atom = angle_per_atom = dihedral_per_atom = improper_per_atom = 0; + bond_negative = angle_negative = dihedral_negative = improper_negative = NULL; +} + +/* ---------------------------------------------------------------------- */ + +AtomVecAmoeba::~AtomVecAmoeba() +{ + delete [] bond_negative; + delete [] angle_negative; + delete [] dihedral_negative; + delete [] improper_negative; +} + +/* ---------------------------------------------------------------------- + set local copies of all grow ptrs used by this class, except defaults + needed in replicate when 2 atom classes exist and it calls pack_restart() +------------------------------------------------------------------------- */ + +void AtomVecAmoeba::grow_pointers() +{ + num_bond = atom->num_bond; + bond_type = atom->bond_type; + num_angle = atom->num_angle; + angle_type = atom->angle_type; + num_dihedral = atom->num_dihedral; + dihedral_type = atom->dihedral_type; + num_improper = atom->num_improper; + improper_type = atom->improper_type; + nspecial = atom->nspecial; + nspecial15 = atom->nspecial15; +} + +/* ---------------------------------------------------------------------- + modify values for AtomVec::pack_restart() to pack +------------------------------------------------------------------------- */ + +void AtomVecAmoeba::pack_restart_pre(int ilocal) +{ + // insure negative vectors are needed length + + if (bond_per_atom < atom->bond_per_atom) { + delete [] bond_negative; + bond_per_atom = atom->bond_per_atom; + bond_negative = new int[bond_per_atom]; + } + if (angle_per_atom < atom->angle_per_atom) { + delete [] angle_negative; + angle_per_atom = atom->angle_per_atom; + angle_negative = new int[angle_per_atom]; + } + if (dihedral_per_atom < atom->dihedral_per_atom) { + delete [] dihedral_negative; + dihedral_per_atom = atom->dihedral_per_atom; + dihedral_negative = new int[dihedral_per_atom]; + } + if (improper_per_atom < atom->improper_per_atom) { + delete [] improper_negative; + improper_per_atom = atom->improper_per_atom; + improper_negative = new int[improper_per_atom]; + } + + // flip any negative types to positive and flag which ones + + any_bond_negative = 0; + for (int m = 0; m < num_bond[ilocal]; m++) { + if (bond_type[ilocal][m] < 0) { + bond_negative[m] = 1; + bond_type[ilocal][m] = -bond_type[ilocal][m]; + any_bond_negative = 1; + } else bond_negative[m] = 0; + } + + any_angle_negative = 0; + for (int m = 0; m < num_angle[ilocal]; m++) { + if (angle_type[ilocal][m] < 0) { + angle_negative[m] = 1; + angle_type[ilocal][m] = -angle_type[ilocal][m]; + any_angle_negative = 1; + } else angle_negative[m] = 0; + } + + any_dihedral_negative = 0; + for (int m = 0; m < num_dihedral[ilocal]; m++) { + if (dihedral_type[ilocal][m] < 0) { + dihedral_negative[m] = 1; + dihedral_type[ilocal][m] = -dihedral_type[ilocal][m]; + any_dihedral_negative = 1; + } else dihedral_negative[m] = 0; + } + + any_improper_negative = 0; + for (int m = 0; m < num_improper[ilocal]; m++) { + if (improper_type[ilocal][m] < 0) { + improper_negative[m] = 1; + improper_type[ilocal][m] = -improper_type[ilocal][m]; + any_improper_negative = 1; + } else improper_negative[m] = 0; + } +} + +/* ---------------------------------------------------------------------- + unmodify values packed by AtomVec::pack_restart() +------------------------------------------------------------------------- */ + +void AtomVecAmoeba::pack_restart_post(int ilocal) +{ + // restore the flagged types to their negative values + + if (any_bond_negative) { + for (int m = 0; m < num_bond[ilocal]; m++) + if (bond_negative[m]) bond_type[ilocal][m] = -bond_type[ilocal][m]; + } + + if (any_angle_negative) { + for (int m = 0; m < num_angle[ilocal]; m++) + if (angle_negative[m]) angle_type[ilocal][m] = -angle_type[ilocal][m]; + } + + if (any_dihedral_negative) { + for (int m = 0; m < num_dihedral[ilocal]; m++) + if (dihedral_negative[m]) + dihedral_type[ilocal][m] = -dihedral_type[ilocal][m]; + } + + if (any_improper_negative) { + for (int m = 0; m < num_improper[ilocal]; m++) + if (improper_negative[m]) + improper_type[ilocal][m] = -improper_type[ilocal][m]; + } +} + +/* ---------------------------------------------------------------------- + initialize other atom quantities after AtomVec::unpack_restart() +------------------------------------------------------------------------- */ + +void AtomVecAmoeba::unpack_restart_init(int ilocal) +{ + nspecial[ilocal][0] = 0; + nspecial[ilocal][1] = 0; + nspecial[ilocal][2] = 0; + nspecial15[ilocal] = 0; +} + +/* ---------------------------------------------------------------------- + modify what AtomVec::data_atom() just unpacked + or initialize other atom quantities +------------------------------------------------------------------------- */ + +void AtomVecAmoeba::data_atom_post(int ilocal) +{ + num_bond[ilocal] = 0; + num_angle[ilocal] = 0; + num_dihedral[ilocal] = 0; + num_improper[ilocal] = 0; + nspecial[ilocal][0] = 0; + nspecial[ilocal][1] = 0; + nspecial[ilocal][2] = 0; + nspecial15[ilocal] = 0; +} diff --git a/src/AMOEBA/atom_vec_amoeba.h b/src/AMOEBA/atom_vec_amoeba.h new file mode 100644 index 0000000000..9f0c075668 --- /dev/null +++ b/src/AMOEBA/atom_vec_amoeba.h @@ -0,0 +1,57 @@ +/* -*- c++ -*- ---------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#ifdef ATOM_CLASS + +AtomStyle(amoeba,AtomVecAmoeba) + +#else + +#ifndef LMP_ATOM_VEC_AMOEBA_H +#define LMP_ATOM_VEC_AMOEBA_H + +#include "atom_vec.h" + +namespace LAMMPS_NS { + +class AtomVecAmoeba : public AtomVec { + public: + AtomVecAmoeba(class LAMMPS *); + ~AtomVecAmoeba(); + + void grow_pointers(); + void pack_restart_pre(int); + void pack_restart_post(int); + void unpack_restart_init(int); + void data_atom_post(int); + + private: + int *num_bond,*num_angle,*num_dihedral,*num_improper; + int **bond_type,**angle_type,**dihedral_type,**improper_type; + int **nspecial; + int *nspecial15,**special15; + + int any_bond_negative,any_angle_negative, + any_dihedral_negative,any_improper_negative; + int bond_per_atom,angle_per_atom,dihedral_per_atom,improper_per_atom; + int *bond_negative,*angle_negative,*dihedral_negative,*improper_negative; +}; + +} + +#endif +#endif + +/* ERROR/WARNING messages: + +*/ diff --git a/src/AMOEBA/pair_amoeba.cpp b/src/AMOEBA/pair_amoeba.cpp new file mode 100644 index 0000000000..f9e098e884 --- /dev/null +++ b/src/AMOEBA/pair_amoeba.cpp @@ -0,0 +1,2317 @@ +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#include "pair_amoeba.h" +#include +#include +#include +#include +#include "amoeba_convolution.h" +#include "atom.h" +#include "update.h" +#include "domain.h" +#include "force.h" +#include "comm.h" +#include "neighbor.h" +#include "neigh_request.h" +#include "neigh_list.h" +#include "group.h" +#include "modify.h" +#include "fix.h" +#include "fix_store.h" +#include "fft3d_wrap.h" +#include "gridcomm.h" +#include "my_page.h" +#include "memory.h" +#include "error.h" +#include "utils.h" + +using namespace LAMMPS_NS; + +enum{INDUCE,RSD,SETUP_AMOEBA,SETUP_HIPPO,KMPOLE,AMGROUP,PVAL}; // forward comm +enum{FIELD,ZRSD,TORQUE,UFLD}; // reverse comm +enum{ARITHMETIC,GEOMETRIC,CUBIC_MEAN,R_MIN,SIGMA,DIAMETER,HARMONIC,HHG,W_H}; +enum{VDWL,REPULSE,QFER,DISP,MPOLE,POLAR,USOLV,DISP_LONG,MPOLE_LONG,POLAR_LONG}; +enum{MPOLE_GRID,POLAR_GRID,POLAR_GRIDC,DISP_GRID,INDUCE_GRID,INDUCE_GRIDC}; +enum{MUTUAL,OPT,TCG,DIRECT}; +enum{GEAR,ASPC,LSQR}; + +#define DELTASTACK 1 // change this when debugged + +/* ---------------------------------------------------------------------- */ + +PairAmoeba::PairAmoeba(LAMMPS *lmp) : Pair(lmp) +{ + // error checks + + if (strcmp(update->unit_style,"real") != 0) + error->all(FLERR,"Pair style amoeba/hippo require real units"); + if (force->newton_pair == 0) + error->all(FLERR,"Pair style amoeba/hippo require newton pair on"); + if (domain->dimension == 2) + error->all(FLERR,"Pair style amoeba/hippo requires 3d system"); + + me = comm->me; + nprocs = comm->nprocs; + + // force field settings + + one_coeff = 1; + single_enable = 0; + + amoeba = 1; + hippo = 0; + + optorder = 0; + maxualt = 0; + tcgnab = 0; + + nmax = 0; + xaxis2local = yaxis2local = zaxis2local = NULL; + rpole = NULL; + tq = NULL; + + ired2local = NULL; + xred = NULL; + + uind = uinp = udirp = NULL; + uopt = uoptp = NULL; + fopt = foptp = NULL; + field = fieldp = NULL; + ufld = dufld = NULL; + rsd = rsdp = NULL; + zrsd = zrsdp = NULL; + + bsordermax = 0; + thetai1 = thetai2 = thetai3 = NULL; + bsmod1 = bsmod2 = bsmod3 = NULL; + bsbuild = NULL; + igrid = NULL; + + m_kspace = p_kspace = pc_kspace = d_kspace = NULL; + i_kspace = ic_kspace = NULL; + + numneigh_dipole = NULL; + firstneigh_dipole = NULL; + firstneigh_dipdip = NULL; + ipage_dipole = NULL; + dpage_dipdip = NULL; + + numneigh_precond = NULL; + firstneigh_precond = NULL; + ipage_precond = NULL; + + firstneigh_pcpc = NULL; + dpage_pcpc = NULL; + + initialize_type_class(); + initialize_vdwl(); + initialize_smallsize(); + + forcefield = NULL; + + id_pole = id_udalt = id_upalt = NULL; + + nualt = 0; + first_flag = 1; + first_flag_compute = 1; + + // use Tinker value = 332.063713 (one extra digit) + // LAMMPS value = 332.06371 + + electric = 332.063713; + //electric = force->qqr2e; + + // factors for FFT grid size + + nfactors = 3; + factors = new int[nfactors]; + factors[0] = 2; + factors[1] = 3; + factors[2] = 5; +} + +/* ---------------------------------------------------------------------- */ + +PairAmoeba::~PairAmoeba() +{ + // check nfix in case all fixes have already been deleted + + if (modify->nfix) { + if (id_pole) modify->delete_fix(id_pole); + if (id_udalt) modify->delete_fix(id_udalt); + if (id_upalt) modify->delete_fix(id_upalt); + } + + delete [] id_pole; + delete [] id_udalt; + delete [] id_upalt; + + memory->destroy(xaxis2local); + memory->destroy(yaxis2local); + memory->destroy(zaxis2local); + memory->destroy(rpole); + memory->destroy(tq); + + memory->destroy(ired2local); + memory->destroy(xred); + + memory->destroy(uind); + memory->destroy(uinp); + memory->destroy(udirp); + memory->destroy(uopt); + memory->destroy(uoptp); + memory->destroy(fopt); + memory->destroy(foptp); + memory->destroy(field); + memory->destroy(fieldp); + memory->destroy(ufld); + memory->destroy(dufld); + memory->destroy(rsd); + memory->destroy(rsdp); + memory->destroy(zrsd); + memory->destroy(zrsdp); + + memory->destroy(thetai1); + memory->destroy(thetai2); + memory->destroy(thetai3); + memory->destroy(bsmod1); + memory->destroy(bsmod2); + memory->destroy(bsmod3); + memory->destroy(bsbuild); + memory->destroy(igrid); + + delete m_kspace; + delete p_kspace; + delete pc_kspace; + delete d_kspace; + delete i_kspace; + delete ic_kspace; + + memory->destroy(numneigh_dipole); + memory->sfree(firstneigh_dipole); + memory->sfree(firstneigh_dipdip); + delete ipage_dipole; + delete dpage_dipdip; + + memory->destroy(numneigh_precond); + memory->sfree(firstneigh_precond); + delete ipage_precond; + + memory->sfree(firstneigh_pcpc); + delete dpage_pcpc; + + deallocate_type_class(); + if (amoeba) deallocate_vdwl(); + deallocate_smallsize(); + + delete [] forcefield; + + if (allocated) { + memory->destroy(setflag); + memory->destroy(cutsq); + } + + delete [] factors; + + // DEBUG + + if (me == 0) { + if (uind_flag) fclose(fp_uind); + } +} + +/* ---------------------------------------------------------------------- */ + +void PairAmoeba::compute(int eflag, int vflag) +{ + // DEBUG timer init + + if (update->ntimestep <= 1) { + time_init = time_hal = time_repulse = time_disp = time_mpole = 0.0; + time_induce = time_polar = time_qxfer = 0.0; + } + + double evdwl; + + evdwl = 0.0; + ev_init(eflag,vflag); + + // zero internal energy, force, virial terms + + zero_energy_force_virial(); + + // grow local vectors and arrays if necessary + + if (atom->nlocal + atom->nghost > nmax) grow_local(); + + // set amtype/amgroup ptrs for rest of compute() to use it + + amtype = atom->ivector[index_amtype]; + amgroup = atom->ivector[index_amgroup]; + + // ------------------------------------------------------------------- + // one-time initializations + // can't do in init_style() b/c these operations require communication + // ------------------------------------------------------------------- + + // assignment of atoms to polarization groups + + if (first_flag_compute) assign_groups(); + + // assigmment of multipole neighbors to each owned atom + // sets xaxis,yaxis,zaxis + // for HIPPO, also set pval for each atom, then ghost comm of pval + + if (first_flag_compute) { + cfstyle = KMPOLE; + comm->forward_comm_pair(this); + kmpole(); + + if (hippo) { + pval = atom->dvector[index_pval]; + double **pole = fixpole->astore; + int nlocal = atom->nlocal; + int itype,iclass; + for (int i = 0; i < nlocal; i++) { + itype = amtype[i]; + iclass = amtype2class[itype]; + pval[i] = pole[i][0] - pcore[iclass]; + } + cfstyle = PVAL; + comm->forward_comm_pair(this); + } + } + + first_flag_compute = 0; + + // ------------------------------------------------------------------- + // end of one-time initializations + // ------------------------------------------------------------------- + + double time0,time1,time2,time3,time4,time5,time6,time7,time8; + + MPI_Barrier(world); + time0 = MPI_Wtime(); + + // if reneighboring step: + // augment neighbor list to include 1-5 neighbor flags + // re-create xyz axis2local and ired2local + // re-create induce neighbor list + + if (neighbor->ago == 0) { + add_onefive_neighbors(); + if (amoeba) find_hydrogen_neighbors(); + find_multipole_neighbors(); + if (induce_flag && poltyp == MUTUAL && pcgprec) precond_neigh(); + } + + // reset KSpace recip matrix if box size/shape change dynamically + + if (domain->box_change) lattice(); + + // compute reduced H coords for owned atoms + // needs to be computed before forward_comm with cfstyle = SETUP + + if (amoeba) { + int j,iclass; + double rdn; + + double **x = atom->x; + int nlocal = atom->nlocal; + + for (int i = 0; i < nlocal; i++) { + j = ired2local[i]; + iclass = amtype2class[amtype[i]]; + rdn = kred[iclass]; + xred[i][0] = rdn*(x[i][0]-x[j][0]) + x[j][0]; + xred[i][1] = rdn*(x[i][1]-x[j][1]) + x[j][1]; + xred[i][2] = rdn*(x[i][2]-x[j][2]) + x[j][2]; + } + } + + // compute rpole for owned atoms + + int nlocal = atom->nlocal; + + for (int i = 0; i < nlocal; i++) { + chkpole(i); + rotmat(i); + rotsite(i); + } + + // communicate quantities needed by ghost atoms: xred, rpole + // for xred, need to account for PBC + + if (amoeba) cfstyle = SETUP_AMOEBA; + else cfstyle = SETUP_HIPPO; + comm->forward_comm_pair(this); + + if (amoeba) pbc_xred(); + + time1 = MPI_Wtime(); + + // ---------------------------------------- + // compute components of force field + // ---------------------------------------- + + // buffered 14-7 Vdwl, pairwise + + if (amoeba && hal_flag) hal(); + time2 = MPI_Wtime(); + + // Pauli repulsion, pairwise + + if (hippo && repulse_flag) repulsion(); + time3 = MPI_Wtime(); + + // Ewald dispersion, pairwise and long range + + if (hippo && disp_flag) dispersion(); + time4 = MPI_Wtime(); + + // multipole, pairwise and long range + + if (mpole_flag) multipole(); + time5 = MPI_Wtime(); + + // induced dipoles, interative CG relaxation + // communicate induce() output values needed by ghost atoms + + if (induce_flag) { + induce(); + cfstyle = INDUCE; + comm->forward_comm_pair(this); + } + time6 = MPI_Wtime(); + + // dipoles, pairwise and long range + + if (polar_flag) polar(); + time7 = MPI_Wtime(); + + // charge transfer, pairwise + + if (hippo && qxfer_flag) charge_transfer(); + + time8 = MPI_Wtime(); + + // energy, force, virial summations + + eng_vdwl = ehal + erepulse + edisp + empole + epolar + eqxfer; + + double **f = atom->f; + nlocal = atom->nlocal; + int nall = nlocal + atom->nghost; + + for (int i = 0; i < nall; i++) { + f[i][0] = fhal[i][0] + frepulse[i][0] + fdisp[i][0] + + fmpole[i][0] + fpolar[i][0] + fqxfer[i][0]; + f[i][1] = fhal[i][1] + frepulse[i][1] + fdisp[i][1] + + fmpole[i][1] + fpolar[i][1] + fqxfer[i][1]; + f[i][2] = fhal[i][2] + frepulse[i][2] + fdisp[i][2] + + fmpole[i][2] + fpolar[i][2] + fqxfer[i][2]; + } + + for (int i = 0; i < 6; i++) + virial[i] = virhal[i] + virrepulse[i] + virdisp[i] + + virpolar[i] + virmpole[i] + virqxfer[i]; + + // virial computation + // NOTE: how does this work for AMOEBA ? + // do all terms get summed this way, or only pairwise + // it is 2x what summed virial[6] above is + + // if (vflag_fdotr) virial_fdotr_compute(); + + // timing information + + time_init += time1 - time0; + time_hal += time2 - time1; + time_repulse += time3 - time2; + time_disp += time4 - time3; + time_mpole += time5 - time4; + time_induce += time6 - time5; + time_polar += time7 - time6; + time_qxfer += time8 - time7; + + // timing output + + if (update->ntimestep < update->laststep) return; + + double ave; + MPI_Allreduce(&time_init,&ave,1,MPI_DOUBLE,MPI_SUM,world); + time_init = ave/nprocs; + + MPI_Allreduce(&time_hal,&ave,1,MPI_DOUBLE,MPI_SUM,world); + time_hal = ave/nprocs; + + MPI_Allreduce(&time_repulse,&ave,1,MPI_DOUBLE,MPI_SUM,world); + time_repulse = ave/nprocs; + + MPI_Allreduce(&time_disp,&ave,1,MPI_DOUBLE,MPI_SUM,world); + time_disp = ave/nprocs; + + MPI_Allreduce(&time_mpole,&ave,1,MPI_DOUBLE,MPI_SUM,world); + time_mpole = ave/nprocs; + + MPI_Allreduce(&time_induce,&ave,1,MPI_DOUBLE,MPI_SUM,world); + time_induce = ave/nprocs; + + MPI_Allreduce(&time_polar,&ave,1,MPI_DOUBLE,MPI_SUM,world); + time_polar = ave/nprocs; + + MPI_Allreduce(&time_qxfer,&ave,1,MPI_DOUBLE,MPI_SUM,world); + time_qxfer = ave/nprocs; + + double time_amtot = time_init + time_hal + time_repulse + time_disp + + time_mpole + time_induce + time_polar + time_qxfer; + + if (me == 0) { + utils::logmesg(lmp,"\nAMEOBA/HIPPO timing info:\n"); + utils::logmesg(lmp," Init time: {:.6g} {:.6g}\n", + time_init,time_init/time_amtot); + utils::logmesg(lmp," Hal time: {:.6g} {:.6g}\n", + time_hal,time_hal/time_amtot*100); + utils::logmesg(lmp," Repls time: {:.6g} {:.6g}\n", + time_repulse,time_repulse/time_amtot*100); + utils::logmesg(lmp," Disp time: {:.6g} {:.6g}\n", + time_disp,time_disp/time_amtot*100); + utils::logmesg(lmp," Mpole time: {:.6g} {:.6g}\n", + time_mpole,time_mpole/time_amtot*100); + utils::logmesg(lmp," Induce time: {:.6g} {:.6g}\n", + time_induce,time_induce/time_amtot*100); + utils::logmesg(lmp," Polar time: {:.6g} {:.6g}\n", + time_polar,time_polar/time_amtot*100); + utils::logmesg(lmp," Qxfer time: {:.6g} {:.6g}\n", + time_qxfer,time_qxfer/time_amtot*100); + utils::logmesg(lmp," Total time: {:.6g}\n\n",time_amtot); + } +} + +/* ---------------------------------------------------------------------- + allocate all arrays +------------------------------------------------------------------------- */ + +void PairAmoeba::allocate() +{ + allocated = 1; + int n = atom->ntypes; + + memory->create(setflag,n+1,n+1,"pair:setflag"); + for (int i = 1; i <= n; i++) + for (int j = i; j <= n; j++) + setflag[i][j] = 0; + + memory->create(cutsq,n+1,n+1,"pair:cutsq"); +} + +/* ---------------------------------------------------------------------- + global settings +------------------------------------------------------------------------- */ + +void PairAmoeba::settings(int narg, char **arg) +{ + // for now, allow turn on/off of individual FF terms + + // if (narg) error->all(FLERR,"Illegal pair_style command"); + + // turn on all FF components by default + + hal_flag = repulse_flag = disp_flag = induce_flag = + polar_flag = mpole_flag = qxfer_flag = 1; + rspace_flag = kspace_flag = 1; + + // turn off debug output by default + + uind_flag = 0; + + // process optional args + // none turns all FF components off + + int iarg = 0; + while (iarg < narg) { + if (strcmp(arg[iarg],"none") == 0) { + hal_flag = repulse_flag = disp_flag = induce_flag = + polar_flag = mpole_flag = qxfer_flag = 0; + rspace_flag = kspace_flag = 0; + } + else if (strcmp(arg[iarg],"hal") == 0) hal_flag = 1; + else if (strcmp(arg[iarg],"repulse") == 0) repulse_flag = 1; + else if (strcmp(arg[iarg],"disp") == 0) disp_flag = 1; + else if (strcmp(arg[iarg],"induce") == 0) induce_flag = 1; + else if (strcmp(arg[iarg],"polar") == 0) polar_flag = 1; + else if (strcmp(arg[iarg],"mpole") == 0) mpole_flag = 1; + else if (strcmp(arg[iarg],"qxfer") == 0) qxfer_flag = 1; + + else if (strcmp(arg[iarg],"rspace") == 0) rspace_flag = 1; + else if (strcmp(arg[iarg],"kspace") == 0) kspace_flag = 1; + else if (strcmp(arg[iarg],"no-rspace") == 0) rspace_flag = 0; + else if (strcmp(arg[iarg],"no-kspace") == 0) kspace_flag = 0; + + // DEBUG flags + + else if (strcmp(arg[iarg],"uind") == 0) uind_flag = 1; + + else error->all(FLERR,"Illegal pair_style command"); + iarg++; + } +} + +/* ---------------------------------------------------------------------- + set coeffs for one or more type pairs +------------------------------------------------------------------------- */ + +void PairAmoeba::coeff(int narg, char **arg) +{ + int i,j; + + if (!allocated) allocate(); + + if (narg < 3 && narg > 4) + error->all(FLERR,"Incorrect args for pair coefficients"); + + // insure I,J args are * * + + if (strcmp(arg[0],"*") != 0 || strcmp(arg[1],"*") != 0) + error->all(FLERR,"Incorrect args for pair coefficients"); + + // set setflag since coeff() called once with I,J = * * + + int n = atom->ntypes; + for (i = 1; i <= n; i++) + for (j = i; j <= n; j++) + setflag[i][j] = 1; + + // read force field PRM file and optional KEY file + + set_defaults(); + read_prmfile(arg[2]); + if (narg == 3) read_keyfile(NULL); + else read_keyfile(arg[3]); + + // required for now, until 1-5 settings are implemented in LAMMPS + + //if (special_hal[4] != 1.0 || special_repel[4] != 1.0 || + // special_disp[4] != 1.0 || special_mpole[4] != 1.0 || + // special_polar_pscale[4] != 1.0 || special_polar_piscale[4] != 1.0 || + // special_polar_wscale[4] != 1.0) + // error->all(FLERR,"AMOEBA 1-5 weights must be 1.0 for now"); + + // compute Vdwl mixing rules, only for AMOEBA + + if (amoeba) { + allocate_vdwl(); + mix(); + } + + // allocate arrays that depend on optorder or maxualt values from keyfile + + allocate_smallsize(); + + // set copt and comp values, now that allocated to 0:optorder + + for (i = 0; i <= optorder; i++) + copt[i] = copm[i] = 0.0; + + if (optorder == 1) { + copt[0] = 0.530; + copt[1] = 0.604; + } else if (optorder == 2) { + copt[0] = 0.042; + copt[1] = 0.635; + copt[2] = 0.414; + } else if (optorder == 3) { + copt[0] = -0.132; + copt[1] = 0.218; + copt[2] = 0.637; + copt[3] = 0.293; + } else if (optorder == 4) { + copt[0] = -0.071; + copt[1] = -0.096; + copt[2] = 0.358; + copt[3] = 0.587; + copt[4] = 0.216; + } else if (optorder == 5) { + copt[0] = -0.005; + copt[1] = -0.129; + copt[2] = -0.026; + copt[3] = 0.465; + copt[4] = 0.528; + copt[5] = 0.161; + } else if (optorder == 6) { + copt[0] = 0.014; + copt[1] = -0.041; + copt[2] = -0.172; + copt[3] = 0.073; + copt[4] = 0.535; + copt[5] = 0.467; + copt[6] = 0.122; + } + + for (i = 0; i <= optorder; i++) + for (j = optorder; j >= i; j--) + copm[i] += copt[j]; +} + +/* ---------------------------------------------------------------------- + init specific to this pair style +------------------------------------------------------------------------- */ + +void PairAmoeba::init_style() +{ + // error checks + + if (!atom->q_flag) + error->all(FLERR,"Pair style amoeba/hippo requires atom attribute q"); + //if (!force->special_onefive) + // error->all(FLERR,"Pair style amoeba/hippo requires special_bonds one/five be set"); + + // b/c induce computes fopt,foptp used by polar + + if (kspace_flag && optorder && polar_flag && !induce_flag) + error->all(FLERR,"Pair amoeba with optorder requires induce and polar together"); + + // b/c polar uses mutipole virial terms + + if (kspace_flag && apewald == aeewald && polar_flag && !mpole_flag) + error->all(FLERR, + "Pair amoeba with apewald = aeewald requires mpole and polar together"); + + // check if all custom atom arrays were set via fix property/atom + + int flag,cols; + + index_amtype = atom->find_custom("amtype",flag,cols); + if (index_amtype < 0 || flag || cols) + error->all(FLERR,"Pair amoeba amtype is not defined"); + index_amgroup = atom->find_custom("amgroup",flag,cols); + if (index_amgroup < 0 || flag || cols) + error->all(FLERR,"Pair amoeba amgroup is not defined"); + + index_ired = atom->find_custom("ired",flag,cols); + if (index_ired < 0 || flag || cols) + error->all(FLERR,"Pair amoeba ired is not defined"); + index_xaxis = atom->find_custom("xaxis",flag,cols); + if (index_xaxis < 0 || flag || cols) + error->all(FLERR,"Pair amoeba xaxis is not defined"); + index_yaxis = atom->find_custom("yaxis",flag,cols); + if (index_yaxis < 0 || flag || cols) + error->all(FLERR,"Pair amoeba yaxis is not defined"); + index_zaxis = atom->find_custom("zaxis",flag,cols); + if (index_zaxis < 0 || flag || cols) + error->all(FLERR,"Pair amoeba zaxis is not defined"); + + index_polaxe = atom->find_custom("polaxe",flag,cols); + if (index_polaxe < 0 || flag || cols) + error->all(FLERR,"Pair amoeba polaxe is not defined"); + index_pval = atom->find_custom("pval",flag,cols); + if (index_pval < 0 || !flag || cols) + error->all(FLERR,"Pair amoeba pval is not defined"); + + // check for fix store/state commands that stores force components + + ifhal = modify->find_fix("fhal"); + ifrepulse = modify->find_fix("frepulse"); + ifdisp = modify->find_fix("fdisp"); + ifpolar = modify->find_fix("fpolar"); + ifmpole = modify->find_fix("fmpole"); + ifqxfer = modify->find_fix("fqxfer"); + + if (ifhal < 0 || ifrepulse < 0 || ifdisp < 0 || + ifpolar < 0 || ifmpole < 0 || ifqxfer < 0) + error->all(FLERR,"Pair amoeba fix store/state commands not defined"); + + // ------------------------------------------------------------------- + // one-time initializations + // can't do earlier b/c need all atoms to exist + // ------------------------------------------------------------------- + + // creation of per-atom storage + // create a new fix STORE style for each atom's pole vector + // id = "AMOEBA_pole", fix group = all + + if (first_flag) { + int n = strlen("AMOEBA_pole") + 1; + id_pole = new char[n]; + strcpy(id_pole,"AMOEBA_pole"); + + char **newarg = new char*[6]; + newarg[0] = id_pole; + newarg[1] = group->names[0]; + newarg[2] = (char *) "STORE"; + newarg[3] = (char *) "peratom"; + newarg[4] = (char *) "1"; + newarg[5] = (char *) "13"; + modify->add_fix(6,newarg); + fixpole = (FixStore *) modify->fix[modify->nfix-1]; + delete [] newarg; + } + + // creation of per-atom storage + // create 2 new fix STORE styles for each atom's induced dipole history info + // id = "AMOEBA_udalt", fix group = all + // id = "AMOEBA_upalt", fix group = all + // only if using preconditioner + + if (first_flag && use_pred) { + char ualt[8]; + sprintf(ualt,"%d",maxualt); + + int n = strlen("AMOEBA_udalt") + 1; + id_udalt = new char[n]; + strcpy(id_udalt,"AMOEBA_udalt"); + + char **newarg = new char*[7]; + newarg[0] = id_udalt; + newarg[1] = group->names[0]; + newarg[2] = (char *) "STORE"; + newarg[3] = (char *) "peratom"; + newarg[4] = (char *) "1"; + newarg[5] = ualt; + newarg[6] = (char *) "3"; + modify->add_fix(7,newarg); + fixudalt = (FixStore *) modify->fix[modify->nfix-1]; + delete [] newarg; + + n = strlen("AMOEBA_upalt") + 1; + id_upalt = new char[n]; + strcpy(id_udalt,"AMOEBA_upalt"); + + newarg = new char*[7]; + newarg[0] = id_upalt; + newarg[1] = group->names[0]; + newarg[2] = (char *) "STORE"; + newarg[3] = (char *) "peratom"; + newarg[4] = (char *) "1"; + newarg[5] = ualt; + newarg[6] = (char *) "3"; + modify->add_fix(7,newarg); + fixupalt = (FixStore *) modify->fix[modify->nfix-1]; + delete [] newarg; + } + + // create pages for storing pairwise data: + // dipole/dipole interactions and preconditioner values + + if (first_flag) { + ipage_dipole = new MyPage(); + dpage_dipdip = new MyPage(); + ipage_dipole->init(neighbor->oneatom,neighbor->pgsize); + dpage_dipdip->init(6*neighbor->oneatom,6*neighbor->pgsize); + + if (poltyp == MUTUAL && pcgprec) { + ipage_precond = new MyPage(); + dpage_pcpc = new MyPage(); + ipage_precond->init(neighbor->oneatom,neighbor->pgsize); + dpage_pcpc->init(6*neighbor->oneatom,6*neighbor->pgsize); + } + } + + // initialize KSpace Ewald settings and FFTs and parallel grid objects + // Coulombic grid is used with two orders: bseorder and bsporder + // so need two GridComm instantiations for ghost comm + + if (first_flag) { + kewald(); + if (use_ewald) { + m_kspace = + new AmoebaConvolution(lmp,this,nefft1,nefft2,nefft3,bseorder,MPOLE_GRID); + p_kspace = + new AmoebaConvolution(lmp,this,nefft1,nefft2,nefft3,bsporder,POLAR_GRID); + pc_kspace = + new AmoebaConvolution(lmp,this,nefft1,nefft2,nefft3,bsporder,POLAR_GRIDC); + i_kspace = + new AmoebaConvolution(lmp,this,nefft1,nefft2,nefft3,bsporder,INDUCE_GRID); + ic_kspace = + new AmoebaConvolution(lmp,this,nefft1,nefft2,nefft3,bsporder,INDUCE_GRIDC); + } + if (use_dewald) { + d_kspace = + new AmoebaConvolution(lmp,this,ndfft1,ndfft2,ndfft3,bsdorder,DISP_GRID); + } + } + + // set csixpr = sum of csix[i]*csix[j] for a double loop over all atoms + // compute this efficiently as M^2 instead of N^2, where M = # of classes + // csix_num[iclass] = # of atoms in class Iclass + + if (first_flag) { + amtype = atom->ivector[index_amtype]; + int nlocal = atom->nlocal; + + int *csix_num_one = new int[n_amclass+1]; + for (int i = 0; i <= n_amclass; i++) csix_num_one[i] = 0; + + int itype,iclass; + + for (int i = 0; i < nlocal; i++) { + itype = amtype[i]; + iclass = amtype2class[itype]; + csix_num_one[iclass]++; + } + + int *csix_num = new int[n_amclass+1]; + MPI_Allreduce(csix_num_one,csix_num,n_amclass+1,MPI_INT,MPI_SUM,world); + + csixpr = 0.0; + for (int i = 1; i <= n_amclass; i++) { + for (int j = i+1; j <= n_amclass; j++) { + csixpr += csix[i]*csix[j] * csix_num[i]*csix_num[j]; + } + } + csixpr *= 2.0; + + for (int i = 1; i <= n_amclass; i++) + csixpr += csix[i]*csix[i] * csix_num[i]*csix_num[i]; + + delete [] csix_num_one; + delete [] csix_num; + } + + // initialize peratom pval to zero + // so that initial ghost comm will be valid + // pval is not set until first call to compute(), and only for HIPPO + + if (first_flag) { + pval = atom->dvector[index_pval]; + int nlocal = atom->nlocal; + for (int i = 0; i < nlocal; i++) pval[i] = 0.0; + } + + // output FF settings to screen and logfile + + if (first_flag) { + if (comm->me == 0) { + if (screen) print_settings(screen); + if (logfile) print_settings(logfile); + } + } + + // all done with one-time initializations + + first_flag = 0; + + // ------------------------------------------------------------------- + // end of one-time initializations + // ------------------------------------------------------------------- + + // check for fixes which store persistent per-atom properties + + if (id_pole) { + int ifix = modify->find_fix(id_pole); + if (ifix < 0) error->all(FLERR,"Could not find pair amoeba fix ID"); + fixpole = (FixStore *) modify->fix[ifix]; + } + + if (id_udalt) { + int ifix = modify->find_fix(id_udalt); + if (ifix < 0) error->all(FLERR,"Could not find pair amoeba fix ID"); + fixudalt = (FixStore *) modify->fix[ifix]; + ifix = modify->find_fix(id_upalt); + if (ifix < 0) error->all(FLERR,"Could not find pair amoeba fix ID"); + fixupalt = (FixStore *) modify->fix[ifix]; + } + + // assign hydrogen neighbors (ired) to each owned atom + // only set if kred[i] is non-zero and I is bonded to a single atom + // conceptually: non-zero if I is a hydrogen bonded to another atom + // NOTE: ired needs to be a tagint vector? but atom ivector is not! + + if (amoeba) { + amtype = atom->ivector[index_amtype]; + ired = atom->ivector[index_ired]; + + int **nspecial = atom->nspecial; + int **special = atom->special; + int nlocal = atom->nlocal; + + int itype,iclass; + + for (int i = 0; i < nlocal; i++) { + itype = amtype[i]; + iclass = amtype2class[itype]; + if (kred[iclass] == 0.0) { + ired[i] = 0; + } + else if (nspecial[i][0] != 1) { + ired[i] = 0; + } + else { + ired[i] = special[i][0]; + } + } + } + + // set KSpace recip matrix based on box size and shape + + lattice(); + + // can now set comm size needed by this Pair + // cfstyle KMPOLE is max # of 1-2 bond partners, smaller than comm_forward + + if (amoeba) comm_forward = 16; // xred, rpole + else if (hippo) comm_forward = 13; // just rpole + int fsize = 6; + if (poltyp == OPT) fsize += 6*optorder; + //if (poltyp == TCG) fsize += 12*tcgnab; + comm_forward = MAX(comm_forward,fsize); + + comm_reverse = 9; + + // request neighbor lists + + int irequest = neighbor->request(this,instance_me); + + // open debug output files + // names are hard-coded + + if (me == 0) { + char fname[32]; + sprintf(fname,"tmp.uind.kspace.%d",nprocs); + if (uind_flag) fp_uind = fopen(fname,"w"); + } +} + +/* ---------------------------------------------------------------------- + print settings to screen and logfile +------------------------------------------------------------------------- */ + +void PairAmoeba::print_settings(FILE *fp) +{ + fprintf(fp,"AMOEBA/HIPPO force field settings\n"); + choose(VDWL); + fprintf(fp," vdwl: cut %g taper %g vscale %g %g %g %g\n", + sqrt(off2),sqrt(cut2), + special_hal[1],special_hal[2],special_hal[3],special_hal[4]); + + choose(REPULSE); + fprintf(fp," repulsion: cut %g taper %g rscale %g %g %g %g\n", + sqrt(off2),sqrt(cut2), + special_repel[1],special_repel[2],special_repel[3],special_repel[4]); + + choose(QFER); + fprintf(fp," qxfer: cut %g taper %g mscale %g %g %g %g\n", + sqrt(off2),sqrt(cut2), + special_mpole[1],special_mpole[2],special_mpole[3],special_mpole[4]); + + if (use_dewald) { + choose(DISP_LONG); + fprintf(fp," dispersion: cut %g aewald %g bsorder %d " + "FFT %d %d %d dspscale %g %g %g %g\n", + sqrt(off2),aewald,bsdorder,ndfft1,ndfft2,ndfft3, + special_disp[1],special_disp[2],special_disp[3],special_disp[4]); + } else { + choose(DISP); + fprintf(fp," dispersion: cut %g aewald %g dspscale %g %g %g %g\n", + sqrt(off2),aewald, + special_disp[1],special_disp[2],special_disp[3],special_disp[4]); + } + + if (use_ewald) { + choose(MPOLE_LONG); + fprintf(fp," multipole: cut %g aewald %g bsorder %d " + "FFT %d %d %d mscale %g %g %g %g\n", + sqrt(off2),aewald,bseorder,nefft1,nefft2,nefft3, + special_mpole[1],special_mpole[2],special_mpole[3],special_mpole[4]); + } else { + choose(MPOLE); + fprintf(fp," multipole: cut %g aewald %g mscale %g %g %g %g\n", + sqrt(off2),aewald, + special_mpole[1],special_mpole[2],special_mpole[3],special_mpole[4]); + } + + if (use_ewald) { + choose(POLAR_LONG); + fprintf(fp," polar: cut %g aewald %g bsorder %d FFT %d %d %d\n", + sqrt(off2),aewald,bsporder,nefft1,nefft2,nefft3); + fprintf(fp," pscale %g %g %g %g piscale %g %g %g %g " + "wscale %g %g %g %g d/u scale %g %g\n", + special_polar_pscale[1],special_polar_pscale[2], + special_polar_pscale[3],special_polar_pscale[4], + special_polar_piscale[1],special_polar_piscale[2], + special_polar_piscale[3],special_polar_piscale[4], + special_polar_wscale[1],special_polar_wscale[2], + special_polar_wscale[3],special_polar_wscale[4], + polar_dscale,polar_uscale); + } else { + choose(POLAR); + fprintf(fp," polar: cut %g aewald %g\n",sqrt(off2),aewald); + fprintf(fp," pscale %g %g %g %g piscale %g %g %g %g " + "wscale %g %g %g %g d/u scale %g %g\n", + special_polar_pscale[1],special_polar_pscale[2], + special_polar_pscale[3],special_polar_pscale[4], + special_polar_piscale[1],special_polar_piscale[2], + special_polar_piscale[3],special_polar_piscale[4], + special_polar_wscale[1],special_polar_wscale[2], + special_polar_wscale[3],special_polar_wscale[4], + polar_dscale,polar_uscale); + } + + choose(USOLV); + fprintf(fp," precondition: cut %g\n",sqrt(off2)); +} + +/* ---------------------------------------------------------------------- + init for one type pair i,j and corresponding j,i +------------------------------------------------------------------------- */ + +double PairAmoeba::init_one(int i, int j) +{ + double cutoff = 0.0; + + if (hal_flag) { + choose(VDWL); + cutoff = MAX(cutoff,sqrt(off2)); + } + if (repulse_flag) { + choose(REPULSE); + cutoff = MAX(cutoff,sqrt(off2)); + } + if (disp_flag) { + if (use_dewald) choose(DISP_LONG); + else choose(DISP); + cutoff = MAX(cutoff,sqrt(off2)); + } + if (mpole_flag) { + if (use_ewald) choose(MPOLE_LONG); + else choose(MPOLE); + cutoff = MAX(cutoff,sqrt(off2)); + } + if (induce_flag) { + if (use_ewald) choose(POLAR_LONG); + else choose(POLAR); + cutoff = MAX(cutoff,sqrt(off2)); + } + if (polar_flag) { + if (use_ewald) choose(POLAR_LONG); + else choose(POLAR); + cutoff = MAX(cutoff,sqrt(off2)); + } + if (qxfer_flag) { + choose(QFER); + cutoff = MAX(cutoff,sqrt(off2)); + } + + return cutoff; +} + +/* ---------------------------------------------------------------------- */ + +int PairAmoeba::pack_forward_comm(int n, int *list, double *buf, + int /*pbc_flag*/, int * /*pbc*/) +{ + int i,j,k,m; + + m = 0; + + if (cfstyle == INDUCE) { + for (i = 0; i < n; i++) { + j = list[i]; + buf[m++] = uind[j][0]; + buf[m++] = uind[j][1]; + buf[m++] = uind[j][2]; + buf[m++] = uinp[j][0]; + buf[m++] = uinp[j][1]; + buf[m++] = uinp[j][2]; + } + + if (poltyp == OPT) { + for (i = 0; i < n; i++) { + j = list[i]; + for (k = 0; k < optorder; k++) { + buf[m++] = uopt[j][k][0]; + buf[m++] = uopt[j][k][1]; + buf[m++] = uopt[j][k][2]; + buf[m++] = uoptp[j][k][0]; + buf[m++] = uoptp[j][k][1]; + buf[m++] = uoptp[j][k][2]; + } + } + } + + /* + if (poltyp == TCG) { + for (i = 0; i < n; i++) { + j = list[i]; + for (k = 0; k < tcgnab; k++) { + buf[m++] = uad[k][j][0]; + buf[m++] = uad[k][j][1]; + buf[m++] = uad[k][j][2]; + buf[m++] = uap[k][j][0]; + buf[m++] = uap[k][j][1]; + buf[m++] = uap[k][j][2]; + buf[m++] = ubd[k][j][0]; + buf[m++] = ubd[k][j][1]; + buf[m++] = ubd[k][j][2]; + buf[m++] = ubp[k][j][0]; + buf[m++] = ubp[k][j][1]; + buf[m++] = ubp[k][j][2]; + } + } + } + */ + + } else if (cfstyle == RSD) { + for (i = 0; i < n; i++) { + j = list[i]; + buf[m++] = rsd[j][0]; + buf[m++] = rsd[j][1]; + buf[m++] = rsd[j][2]; + buf[m++] = rsdp[j][0]; + buf[m++] = rsdp[j][1]; + buf[m++] = rsdp[j][2]; + } + + } else if (cfstyle == SETUP_AMOEBA) { + for (i = 0; i < n; i++) { + j = list[i]; + buf[m++] = xred[j][0]; + buf[m++] = xred[j][1]; + buf[m++] = xred[j][2]; + for (k = 0; k < 13; k++) + buf[m++] = rpole[j][k]; + } + + } else if (cfstyle == SETUP_HIPPO) { + for (i = 0; i < n; i++) { + j = list[i]; + for (k = 0; k < 13; k++) + buf[m++] = rpole[j][k]; + } + + } else if (cfstyle == KMPOLE) { + int **nspecial = atom->nspecial; + int **special = atom->special; + for (i = 0; i < n; i++) { + j = list[i]; + buf[m++] = ubuf(nspecial[j][0]).d; + for (k = 0; k < nspecial[j][0]; k++) + buf[m++] = ubuf(special[j][k]).d; + } + + } else if (cfstyle == AMGROUP) { + for (i = 0; i < n; i++) { + j = list[i]; + buf[m++] = ubuf(amgroup[j]).d; + } + + } else if (cfstyle == PVAL) { + for (i = 0; i < n; i++) { + j = list[i]; + buf[m++] = pval[j]; + } + } + + return m; +} + +/* ---------------------------------------------------------------------- */ + +void PairAmoeba::unpack_forward_comm(int n, int first, double *buf) +{ + int i,k,m,last; + + m = 0; + last = first + n; + + if (cfstyle == INDUCE) { + for (i = first; i < last; i++) { + uind[i][0] = buf[m++]; + uind[i][1] = buf[m++]; + uind[i][2] = buf[m++]; + uinp[i][0] = buf[m++]; + uinp[i][1] = buf[m++]; + uinp[i][2] = buf[m++]; + } + + if (poltyp == OPT) { + for (i = first; i < last; i++) { + for (k = 0; k < optorder; k++) { + uopt[i][k][0] = buf[m++]; + uopt[i][k][1] = buf[m++]; + uopt[i][k][2] = buf[m++]; + uoptp[i][k][0] = buf[m++]; + uoptp[i][k][1] = buf[m++]; + uoptp[i][k][2] = buf[m++]; + } + } + } + + /* + if (poltyp == TCG) { + for (i = first; i < last; i++) { + for (k = 0; k < tcgnab; k++) { + uad[k][i][0] = buf[m++]; + uad[k][i][1] = buf[m++]; + uad[k][i][2] = buf[m++]; + uap[k][i][0] = buf[m++]; + uap[k][i][1] = buf[m++]; + uap[k][i][2] = buf[m++]; + ubd[k][i][0] = buf[m++]; + ubd[k][i][1] = buf[m++]; + ubd[k][i][2] = buf[m++]; + ubp[k][i][0] = buf[m++]; + ubp[k][i][1] = buf[m++]; + ubp[k][i][2] = buf[m++]; + } + } + } + */ + + } else if (cfstyle == RSD) { + for (i = first; i < last; i++) { + rsd[i][0] = buf[m++]; + rsd[i][1] = buf[m++]; + rsd[i][2] = buf[m++]; + rsdp[i][0] = buf[m++]; + rsdp[i][1] = buf[m++]; + rsdp[i][2] = buf[m++]; + } + + } else if (cfstyle == SETUP_AMOEBA) { + for (i = first; i < last; i++) { + xred[i][0] = buf[m++]; + xred[i][1] = buf[m++]; + xred[i][2] = buf[m++]; + for (k = 0; k < 13; k++) + rpole[i][k] = buf[m++]; + } + + } else if (cfstyle == SETUP_HIPPO) { + for (i = first; i < last; i++) { + for (k = 0; k < 13; k++) + rpole[i][k] = buf[m++]; + } + + + } else if (cfstyle == KMPOLE) { + int **nspecial = atom->nspecial; + int **special = atom->special; + for (i = first; i < last; i++) { + nspecial[i][0] = (int) ubuf(buf[m++]).i; + for (k = 0; k < nspecial[i][0]; k++) + special[i][k] = (tagint) ubuf(buf[m++]).i; + } + + } else if (cfstyle == AMGROUP) { + for (i = first; i < last; i++) { + amgroup[i] = (int) ubuf(buf[m++]).i; + } + + } else if (cfstyle == PVAL) { + for (i = first; i < last; i++) { + pval[i] = buf[m++]; + } + } +} + +/* ---------------------------------------------------------------------- */ + +int PairAmoeba::pack_reverse_comm(int n, int first, double *buf) +{ + int i,m,last; + + m = 0; + last = first + n; + + if (crstyle == FIELD) { + for (i = first; i < last; i++) { + buf[m++] = field[i][0]; + buf[m++] = field[i][1]; + buf[m++] = field[i][2]; + buf[m++] = fieldp[i][0]; + buf[m++] = fieldp[i][1]; + buf[m++] = fieldp[i][2]; + } + } else if (crstyle == ZRSD) { + for (i = first; i < last; i++) { + buf[m++] = zrsd[i][0]; + buf[m++] = zrsd[i][1]; + buf[m++] = zrsd[i][2]; + buf[m++] = zrsdp[i][0]; + buf[m++] = zrsdp[i][1]; + buf[m++] = zrsdp[i][2]; + } + } else if (crstyle == TORQUE) { + for (i = first; i < last; i++) { + buf[m++] = tq[i][0]; + buf[m++] = tq[i][1]; + buf[m++] = tq[i][2]; + } + } else if (crstyle == UFLD) { + for (i = first; i < last; i++) { + buf[m++] = ufld[i][0]; + buf[m++] = ufld[i][1]; + buf[m++] = ufld[i][2]; + buf[m++] = dufld[i][0]; + buf[m++] = dufld[i][1]; + buf[m++] = dufld[i][2]; + buf[m++] = dufld[i][3]; + buf[m++] = dufld[i][4]; + buf[m++] = dufld[i][5]; + } + } + + return m; +} + +/* ---------------------------------------------------------------------- */ + +void PairAmoeba::unpack_reverse_comm(int n, int *list, double *buf) +{ + int i,j,m; + + m = 0; + + if (crstyle == FIELD) { + for (i = 0; i < n; i++) { + j = list[i]; + field[j][0] += buf[m++]; + field[j][1] += buf[m++]; + field[j][2] += buf[m++]; + fieldp[j][0] += buf[m++]; + fieldp[j][1] += buf[m++]; + fieldp[j][2] += buf[m++]; + } + } else if (crstyle == ZRSD) { + for (i = 0; i < n; i++) { + j = list[i]; + zrsd[j][0] += buf[m++]; + zrsd[j][1] += buf[m++]; + zrsd[j][2] += buf[m++]; + zrsdp[j][0] += buf[m++]; + zrsdp[j][1] += buf[m++]; + zrsdp[j][2] += buf[m++]; + } + } else if (crstyle == TORQUE) { + for (i = 0; i < n; i++) { + j = list[i]; + tq[j][0] += buf[m++]; + tq[j][1] += buf[m++]; + tq[j][2] += buf[m++]; + } + } else if (crstyle == UFLD) { + for (i = 0; i < n; i++) { + j = list[i]; + ufld[j][0] += buf[m++]; + ufld[j][1] += buf[m++]; + ufld[j][2] += buf[m++]; + dufld[j][0] += buf[m++]; + dufld[j][1] += buf[m++]; + dufld[j][2] += buf[m++]; + dufld[j][3] += buf[m++]; + dufld[j][4] += buf[m++]; + dufld[j][5] += buf[m++]; + } + } +} + +/* ---------------------------------------------------------------------- + pack own values to buf to send to another proc +------------------------------------------------------------------------- */ + +void PairAmoeba::pack_forward_grid(int flag, void *vbuf, int nlist, int *list) +{ + FFT_SCALAR *buf = (FFT_SCALAR *) vbuf; + + if (flag == MPOLE_GRID) { + FFT_SCALAR *src = m_kspace->grid_brick_start; + for (int i = 0; i < nlist; i++) + buf[i] = src[list[i]]; + } else if (flag == POLAR_GRID) { + FFT_SCALAR *src = p_kspace->grid_brick_start; + for (int i = 0; i < nlist; i++) + buf[i] = src[list[i]]; + } else if (flag == POLAR_GRIDC) { + FFT_SCALAR *src = pc_kspace->grid_brick_start; + int n = 0; + for (int i = 0; i < nlist; i++) { + buf[n++] = src[2*list[i]]; + buf[n++] = src[2*list[i]+1]; + } + } else if (flag == DISP_GRID) { + FFT_SCALAR *src = d_kspace->grid_brick_start; + for (int i = 0; i < nlist; i++) + buf[i] = src[list[i]]; + } else if (flag == INDUCE_GRID) { + FFT_SCALAR *src = i_kspace->grid_brick_start; + for (int i = 0; i < nlist; i++) + buf[i] = src[list[i]]; + } else if (flag == INDUCE_GRIDC) { + FFT_SCALAR *src = ic_kspace->grid_brick_start; + int n = 0; + for (int i = 0; i < nlist; i++) { + buf[n++] = src[2*list[i]]; + buf[n++] = src[2*list[i]+1]; + } + } +} + +/* ---------------------------------------------------------------------- + unpack another proc's own values from buf and set own ghost values +------------------------------------------------------------------------- */ + +void PairAmoeba::unpack_forward_grid(int flag, void *vbuf, int nlist, int *list) +{ + FFT_SCALAR *buf = (FFT_SCALAR *) vbuf; + + if (flag == MPOLE_GRID) { + FFT_SCALAR *dest = m_kspace->grid_brick_start; + for (int i = 0; i < nlist; i++) + dest[list[i]] = buf[i]; + } else if (flag == POLAR_GRID) { + FFT_SCALAR *dest = p_kspace->grid_brick_start; + for (int i = 0; i < nlist; i++) + dest[list[i]] = buf[i]; + } else if (flag == POLAR_GRIDC) { + FFT_SCALAR *dest = pc_kspace->grid_brick_start; + int n = 0; + for (int i = 0; i < nlist; i++) { + dest[2*list[i]] = buf[n++]; + dest[2*list[i]+1] = buf[n++]; + } + } else if (flag == DISP_GRID) { + FFT_SCALAR *dest = d_kspace->grid_brick_start; + for (int i = 0; i < nlist; i++) + dest[list[i]] = buf[i]; + } else if (flag == INDUCE_GRID) { + FFT_SCALAR *dest = i_kspace->grid_brick_start; + for (int i = 0; i < nlist; i++) + dest[list[i]] = buf[i]; + } else if (flag == INDUCE_GRIDC) { + FFT_SCALAR *dest = ic_kspace->grid_brick_start; + int n = 0; + for (int i = 0; i < nlist; i++) { + dest[2*list[i]] = buf[n++]; + dest[2*list[i]+1] = buf[n++]; + } + } +} + +/* ---------------------------------------------------------------------- + pack ghost values into buf to send to another proc +------------------------------------------------------------------------- */ + +void PairAmoeba::pack_reverse_grid(int flag, void *vbuf, int nlist, int *list) +{ + FFT_SCALAR *buf = (FFT_SCALAR *) vbuf; + + if (flag == MPOLE_GRID) { + FFT_SCALAR *src = m_kspace->grid_brick_start; + for (int i = 0; i < nlist; i++) + buf[i] = src[list[i]]; + } else if (flag == POLAR_GRID) { + FFT_SCALAR *src = p_kspace->grid_brick_start; + for (int i = 0; i < nlist; i++) + buf[i] = src[list[i]]; + } else if (flag == POLAR_GRIDC) { + FFT_SCALAR *src = pc_kspace->grid_brick_start; + int n = 0; + for (int i = 0; i < nlist; i++) { + buf[n++] = src[2*list[i]]; + buf[n++] = src[2*list[i]+1]; + } + } else if (flag == DISP_GRID) { + FFT_SCALAR *src = d_kspace->grid_brick_start; + for (int i = 0; i < nlist; i++) + buf[i] = src[list[i]]; + } else if (flag == INDUCE_GRID) { + FFT_SCALAR *src = i_kspace->grid_brick_start; + for (int i = 0; i < nlist; i++) + buf[i] = src[list[i]]; + } else if (flag == INDUCE_GRIDC) { + FFT_SCALAR *src = ic_kspace->grid_brick_start; + int n = 0; + for (int i = 0; i < nlist; i++) { + buf[n++] = src[2*list[i]]; + buf[n++] = src[2*list[i]+1]; + } + } +} + +/* ---------------------------------------------------------------------- + unpack another proc's ghost values from buf and add to own values +------------------------------------------------------------------------- */ + +void PairAmoeba::unpack_reverse_grid(int flag, void *vbuf, int nlist, int *list) +{ + FFT_SCALAR *buf = (FFT_SCALAR *) vbuf; + + if (flag == MPOLE_GRID) { + FFT_SCALAR *dest = m_kspace->grid_brick_start; + for (int i = 0; i < nlist; i++) + dest[list[i]] += buf[i]; + } else if (flag == POLAR_GRID) { + FFT_SCALAR *dest = p_kspace->grid_brick_start; + for (int i = 0; i < nlist; i++) + dest[list[i]] += buf[i]; + } else if (flag == POLAR_GRIDC) { + FFT_SCALAR *dest = pc_kspace->grid_brick_start; + int n = 0; + for (int i = 0; i < nlist; i++) { + dest[2*list[i]] += buf[n++]; + dest[2*list[i]+1] += buf[n++]; + } + } else if (flag == DISP_GRID) { + FFT_SCALAR *dest = d_kspace->grid_brick_start; + for (int i = 0; i < nlist; i++) + dest[list[i]] += buf[i]; + } else if (flag == INDUCE_GRID) { + FFT_SCALAR *dest = i_kspace->grid_brick_start; + for (int i = 0; i < nlist; i++) + dest[list[i]] += buf[i]; + } else if (flag == INDUCE_GRIDC) { + FFT_SCALAR *dest = ic_kspace->grid_brick_start; + int n = 0; + for (int i = 0; i < nlist; i++) { + dest[2*list[i]] += buf[n++]; + dest[2*list[i]+1] += buf[n++]; + } + } +} + +// ---------------------------------------------------------------------- +// AMOEBA/HIPPO specific methods +// ---------------------------------------------------------------------- + +/* ---------------------------------------------------------------------- + assign atoms to polarization groups with unique IDs +------------------------------------------------------------------------- */ + +void PairAmoeba::assign_groups() +{ + int i,j,m,jtype,mtype; + int nbond,ngroup,ibond,igroup,ghostmark,anyghostmark; + tagint jglobal; + + int nstack = 0; + int maxstack = 0; + int *stack = NULL; + + int **special = atom->special; + int **nspecial = atom->nspecial; + tagint *tag = atom->tag; + int nlocal = atom->nlocal; + int nall = nlocal + atom->nghost; + + // initially, groupID = atomID + // communicate new groupIDs to ghost atoms + + for (i = 0; i < nlocal; i++) amgroup[i] = tag[i]; + cfstyle = AMGROUP; + comm->forward_comm_pair(this); + + // loop until no ghost atom groupIDs are reset + + while (1) { + + // loop over all atoms and their group neighborhoods + + ghostmark = 0; + for (i = 0; i < nlocal; i++) { + + // push atom I on stack + + nstack = 0; + if (nstack == maxstack) { + maxstack += DELTASTACK; + memory->grow(stack,maxstack,"amoeba:stack"); + } + stack[nstack++] = i; + + // loop over I's group neighborhood until stack is empty + + while (nstack > 0) { + + // pop atom M off stack + + m = stack[nstack-1]; + nstack--; + mtype = amtype[m]; + + // loop over bond partners of atom M + + nbond = nspecial[m][0]; + for (ibond = 0; ibond < nbond; ibond++) { + jglobal = special[m][ibond]; + j = atom->map(jglobal); + if (j < 0) + error->one(FLERR,"AMOEBA group assignment bond neighbor not found"); + jtype = amtype[j]; + + // if amtype of bondpartner J is not in polgroup of atom M, continue + + ngroup = npolgroup[mtype]; + for (igroup = 0; igroup < ngroup; igroup++) + if (jtype == polgroup[mtype][igroup]) break; + if (igroup == ngroup) continue; + + // if groupID of atoms J and M are the same, continue + // else set atom with larger groupID to smaller groupID + // if changed atom is ghost, set ghostmark, else push atom on stack + + if (amgroup[m] == amgroup[j]) continue; + + if (amgroup[m] > amgroup[j]) { + amgroup[m] = amgroup[j]; + if (nstack == maxstack) { + maxstack += DELTASTACK; + memory->grow(stack,maxstack,"amoeba:stack"); + } + stack[nstack++] = m; + } else { + amgroup[j] = amgroup[m]; + if (j >= nlocal) ghostmark = 1; + else { + if (nstack == maxstack) { + maxstack += DELTASTACK; + memory->grow(stack,maxstack,"amoeba:stack"); + } + stack[nstack++] = j; + } + } + } + } + } + + // communicate new groupIDs to ghost atoms + + cfstyle = AMGROUP; + comm->forward_comm_pair(this); + + // done if no proc reset groupID of a ghost atom + + MPI_Allreduce(&ghostmark,&anyghostmark,1,MPI_INT,MPI_MAX,world); + if (!anyghostmark) break; + } + + memory->destroy(stack); + + // print group count + + int count = 0; + for (i = 0; i < nlocal; i++) + if (tag[i] == amgroup[i]) count++; + bigint bcount = count; + bigint allbcount; + MPI_Allreduce(&bcount,&allbcount,1,MPI_LMP_BIGINT,MPI_SUM,world); + + if (comm->me == 0) { + if (screen) + fprintf(screen," AMOEBA/HIPPO group count: " BIGINT_FORMAT "\n",allbcount); + if (logfile) + fprintf(logfile," AMOEBA/HIPPO group count: " BIGINT_FORMAT "\n",allbcount); + } +} + +/* ---------------------------------------------------------------------- + adjust xred for ghost atoms due to PBC +------------------------------------------------------------------------- */ + +void PairAmoeba::pbc_xred() +{ + double prd,prd_half,delta; + + double **x = atom->x; + int nlocal = atom->nlocal; + int nall = nlocal + atom->nghost; + + if (domain->xperiodic) { + prd = domain->xprd; + prd_half = domain->xprd_half; + for (int i = nlocal; i < nall; i++) { + delta = xred[i][0] - x[i][0]; + while (fabs(delta) > prd_half) { + if (delta < 0.0) xred[i][0] += prd; + else xred[i][0] -= prd; + delta = xred[i][0] - x[i][0]; + } + } + } + + if (domain->yperiodic) { + prd = domain->yprd; + prd_half = domain->yprd_half; + for (int i = nlocal; i < nall; i++) { + delta = xred[i][1] - x[i][1]; + while (fabs(delta) > prd_half) { + if (delta < 0.0) xred[i][1] += prd; + else xred[i][1] -= prd; + delta = xred[i][1] - x[i][1]; + } + } + } + + if (domain->zperiodic) { + prd = domain->zprd; + prd_half = domain->zprd_half; + for (int i = nlocal; i < nall; i++) { + delta = xred[i][2] - x[i][2]; + while (fabs(delta) > prd_half) { + if (delta < 0.0) xred[i][2] += prd; + else xred[i][2] -= prd; + delta = xred[i][2] - x[i][2]; + } + } + } +} + +/* ---------------------------------------------------------------------- + build reduced-size preconditioner neigh list from master neigh list +------------------------------------------------------------------------- */ + +void PairAmoeba::precond_neigh() +{ + int i,j,ii,jj,n,inum,jnum; + double xtmp,ytmp,ztmp,delx,dely,delz,rsq; + int *ilist,*jlist,*numneigh,**firstneigh; + int *neighptr; + + // set cutoffs and taper coeffs + // NOTE: should this cutoff include skin = 2.0 ? + // Josh is checking + + choose(USOLV); + + // atoms and neighbor list + + double **x = atom->x; + + inum = list->inum; + ilist = list->ilist; + numneigh = list->numneigh; + firstneigh = list->firstneigh; + + // store all induce neighs of owned atoms + // scan full neighbor list of I + + ipage_precond->reset(); + + for (ii = 0; ii < inum; ii++) { + i = ilist[ii]; + + n = 0; + neighptr = ipage_precond->vget(); + + xtmp = x[i][0]; + ytmp = x[i][1]; + ztmp = x[i][2]; + + jlist = firstneigh[i]; + jnum = numneigh[i]; + + for (jj = 0; jj < jnum; jj++) { + j = jlist[jj]; + j &= NEIGHMASK15; + delx = xtmp - x[j][0]; + dely = ytmp - x[j][1]; + delz = ztmp - x[j][2]; + rsq = delx*delx + dely*dely + delz*delz; + + if (rsq < off2) neighptr[n++] = jlist[jj]; + } + + firstneigh_precond[i] = neighptr; + numneigh_precond[i] = n; + ipage_precond->vgot(n); + } +} + +/* ---------------------------------------------------------------------- + allocate Vdwl arrays +------------------------------------------------------------------------- */ + +void PairAmoeba::initialize_vdwl() +{ + radmin = radmin4 = epsilon = epsilon4 = NULL; +} + +// NOTE: n_amclass may be much larger than actual atom classes ?? +// due to format of Tinker PRM file + +void PairAmoeba::allocate_vdwl() +{ + memory->create(radmin,n_amclass+1,n_amclass+1,"amoeba:radmin"); + memory->create(radmin4,n_amclass+1,n_amclass+1,"amoeba:radmin4"); + memory->create(epsilon,n_amclass+1,n_amclass+1,"amoeba:epsilon"); + memory->create(epsilon4,n_amclass+1,n_amclass+1,"amoeba:epsilon4"); +} + +void PairAmoeba::deallocate_vdwl() +{ + memory->destroy(radmin); + memory->destroy(radmin4); + memory->destroy(epsilon); + memory->destroy(epsilon4); +} + +/* ---------------------------------------------------------------------- + allocate small-size arrays +------------------------------------------------------------------------- */ + +void PairAmoeba::initialize_smallsize() +{ + copt = copm = NULL; + a_ualt = ap_ualt = NULL; + b_ualt = bp_ualt = NULL; + c_ualt = cp_ualt = NULL; + bpred = bpredp = bpreds = bpredps = NULL; + gear = aspc = NULL; +} + +void PairAmoeba::allocate_smallsize() +{ + // NOTE: are optorder and maxualt always initialized ? + // maybe there should be if tests here + + // note use of optorder+1 + + copt = new double[optorder+1]; + copm = new double[optorder+1]; + + a_ualt = new double[maxualt*(maxualt+1)/2]; + ap_ualt = new double[maxualt*(maxualt+1)/2]; + b_ualt = new double[maxualt]; + bp_ualt = new double[maxualt]; + memory->create(c_ualt,maxualt,maxualt,"amoeba:c_ualt"); + memory->create(cp_ualt,maxualt,maxualt,"amoeba:cp_ualt"); + bpred = new double[maxualt]; + bpredp = new double[maxualt]; + bpreds = new double[maxualt]; + bpredps = new double[maxualt]; + if (use_pred) { + if (polpred == GEAR) gear = new double[maxualt]; + if (polpred == ASPC) aspc = new double[maxualt]; + } +} + +void PairAmoeba::deallocate_smallsize() +{ + delete [] copt; + delete [] copm; + delete [] a_ualt; + delete [] ap_ualt; + delete [] b_ualt; + delete [] bp_ualt; + memory->destroy(c_ualt); + memory->destroy(cp_ualt); + delete [] bpred; + delete [] bpredp; + delete [] bpreds; + delete [] bpredps; + delete [] gear; + delete [] aspc; +} + +/* ---------------------------------------------------------------------- + set cutoffs, taper constants, PME params for a FF component +------------------------------------------------------------------------- */ + +void PairAmoeba::choose(int which) +{ + double off,cut; + + // short-range only terms + + if (which == VDWL) { + off = vdwcut; + cut = vdwtaper; + } else if (which == REPULSE) { + off = repcut; + cut = reptaper; + } else if (which == QFER) { + off = ctrncut; + cut = ctrntaper; + } else if (which == DISP) { + off = dispcut; + cut = disptaper; + aewald = 0.0; + } else if (which == MPOLE) { + off = mpolecut; + cut = mpoletaper; + aewald = 0.0; + } else if (which == POLAR) { + off = ewaldcut; + cut = 0.99*off; // not used + aewald = 0.0; + } else if (which == USOLV) { + off = usolvcut; + cut = 0.99*off; // not used + + // short-range + long-range terms + + } else if (which == DISP_LONG) { + off = dispcut; + cut = 0.99*cut; // not used + aewald = adewald; + } else if (which == MPOLE_LONG) { + off = mpolecut; + cut = 0.99*cut; // not used + aewald = aeewald; + } else if (which == POLAR_LONG) { + off = ewaldcut; + cut = 0.99*off; // not used + aewald = apewald; + } + + off2 = off*off; + cut2 = cut*cut; + + // taper coeffs + + double denom = pow(off-cut,5.0); + c0 = off*off2 * (off2 - 5.0*off*cut + 10.0*cut2) / denom; + c1 = -30.0 * off2*cut2 / denom; + c2 = 30.0 * (off2*cut+off*cut2) / denom; + c3 = -10.0 * (off2 + 4.0*off*cut + cut2) / denom; + c4 = 15.0 * (off+cut) / denom; + c5 = -6.0 / denom; +} + +/* ---------------------------------------------------------------------- + compute mixing rules for all pairwise params on a per-class basis + override default mixing with VDWLPR entries in force field file + NOTE: not yet processing explicit VDWL14 entries in force field file +------------------------------------------------------------------------- */ + +void PairAmoeba::mix() +{ + int i,j,m; + double ei,ej,sei,sej,eij; + double ri,rj,sri,srj,rij; + + double TWOSIX = pow(2.0,1.0/6.0); + + for (i = 1; i <= n_amclass; i++) { + + // printf("MIX i %d nclass %d eps %g sigma %g\n", + // i,n_amclass,vdwl_eps[i],vdwl_sigma[i]); + + for (j = i; j <= n_amclass; j++) { + ei = vdwl_eps[i]; + ej = vdwl_eps[j]; + ri = vdwl_sigma[i]; + rj = vdwl_sigma[j]; + + if (radius_type == SIGMA) { + ri *= TWOSIX; + rj *= TWOSIX; + } + if (radius_size == DIAMETER) { + ri *= 0.5; + rj *= 0.5; + } + + sri = sqrt(ri); + ei = fabs(ei); + sei = sqrt(ei); + srj = sqrt(rj); + ej = fabs(ej); + sej = sqrt(ej); + + if (ri == 0.0 && rj == 0.0) { + rij = 0.0; + } else if (radius_rule == ARITHMETIC) { + rij = ri + rj; + } else if (radius_rule == GEOMETRIC) { + rij = 2.0 * sri * srj; + } else if (radius_rule == CUBIC_MEAN) { + rij = 2.0 * (ri*ri*ri + rj*rj*rj) / (ri*ri + rj*rj); + } else { + rij = ri + rj; + } + + if (ei == 0.0 && ej == 0.0) { + eij = 0.0; + } else if (epsilon_rule == ARITHMETIC) { + eij = 0.5 * (ei + ej); + } else if (epsilon_rule == GEOMETRIC) { + eij = sei * sej; + } else if (epsilon_rule == HARMONIC) { + eij = 2.0 * (ei*ej) / (ei+ej); + } else if (epsilon_rule == HHG) { + eij = 4.0 * (ei*ej) / ((sei+sej)*(sei+sej)); + } else if (epsilon_rule == W_H) { + eij = 2.0 * (sei*sej) * pow(ri*rj,3.0) / (pow(ri,6.0) + pow(rj,6.0)); + } else { + eij = sei * sej; + } + + radmin[j][i] = radmin[i][j] = rij; + radmin4[j][i] = radmin4[i][j] = rij; + epsilon[j][i] = epsilon[i][j] = eij; + epsilon4[j][i] = epsilon4[i][j] = eij; + } + } + + // override with VDWPR pairwise entries from force field file + + for (m = 0; m < nvdwl_pair; m++) { + i = vdwl_class_pair[m][0]; + j = vdwl_class_pair[m][1]; + rij = vdwl_sigma_pair[m]; + eij = vdwl_eps_pair[m]; + + if (radius_type == SIGMA) rij *= TWOSIX; + + radmin[j][i] = radmin[i][j] = rij; + radmin4[j][i] = radmin4[i][j] = rij; + epsilon[j][i] = epsilon[i][j] = eij; + epsilon4[j][i] = epsilon4[i][j] = eij; + } +} + +/* ---------------------------------------------------------------------- + zero internal energy and virial terms +------------------------------------------------------------------------- */ + +void PairAmoeba::zero_energy_force_virial() +{ + ehal = erepulse = edisp = epolar = empole = eqxfer = 0.0; + + fhal = modify->fix[ifhal]->array_atom; + frepulse = modify->fix[ifrepulse]->array_atom; + fdisp = modify->fix[ifdisp]->array_atom; + fpolar = modify->fix[ifpolar]->array_atom; + fmpole = modify->fix[ifmpole]->array_atom; + fqxfer = modify->fix[ifqxfer]->array_atom; + + int nlocal = atom->nlocal; + int nall = nlocal + atom->nghost; + + memset(&fhal[0][0],0,3*nall*sizeof(double)); + memset(&frepulse[0][0],0,3*nall*sizeof(double)); + memset(&fdisp[0][0],0,3*nall*sizeof(double)); + memset(&fpolar[0][0],0,3*nall*sizeof(double)); + memset(&fmpole[0][0],0,3*nall*sizeof(double)); + memset(&fqxfer[0][0],0,3*nall*sizeof(double)); + + for (int i = 0; i < 6; i++) { + virhal[i] = 0.0; + virrepulse[i] = 0.0; + virdisp[i] = 0.0; + virpolar[i] = 0.0; + virmpole[i] = 0.0; + virqxfer[i] = 0.0; + } +} + +/* ---------------------------------------------------------------------- + grow local vectors and arrays if necessary + keep them atom->nmax in length + NOTE: some of these do not need to grow unless nlocal > atom->nmax + these are ones that never store ghost values + could realloc them separately + e.g. thetai,igrid,fopt +------------------------------------------------------------------------- */ + +void PairAmoeba::grow_local() +{ + // free vectors and arrays + + memory->destroy(xaxis2local); + memory->destroy(yaxis2local); + memory->destroy(zaxis2local); + memory->destroy(rpole); + memory->destroy(tq); + + if (amoeba) { + memory->destroy(ired2local); + memory->destroy(xred); + } + + memory->destroy(uind); + memory->destroy(uinp); + memory->destroy(udirp); + if (poltyp == OPT) { + memory->destroy(uopt); + memory->destroy(uoptp); + memory->destroy(fopt); + memory->destroy(foptp); + } + memory->destroy(field); + memory->destroy(fieldp); + memory->destroy(ufld); + memory->destroy(dufld); + memory->destroy(rsd); + memory->destroy(rsdp); + memory->destroy(zrsd); + memory->destroy(zrsdp); + + memory->destroy(thetai1); + memory->destroy(thetai2); + memory->destroy(thetai3); + memory->destroy(igrid); + + memory->destroy(numneigh_dipole); + memory->sfree(firstneigh_dipole); + memory->sfree(firstneigh_dipdip); + + if (poltyp == MUTUAL && pcgprec) { + memory->destroy(numneigh_precond); + memory->sfree(firstneigh_precond); + memory->sfree(firstneigh_pcpc); + } + + // reset nmax + + nmax = atom->nmax; + + // re-allocate vectors and arrays + // note use of optorder+1 for uopt and uoptp + + memory->create(xaxis2local,nmax,"amoeba:xaxis2local"); + memory->create(yaxis2local,nmax,"amoeba:yaxis2local"); + memory->create(zaxis2local,nmax,"amoeba:zaxis2local"); + memory->create(rpole,nmax,13,"amoeba:rpole"); + memory->create(tq,nmax,3,"amoeba:tq"); + + if (amoeba) { + memory->create(ired2local,nmax,"amoeba:ired2local"); + memory->create(xred,nmax,3,"amoeba:xred"); + } + + memory->create(uind,nmax,3,"amoeba:uind"); + memory->create(uinp,nmax,3,"amoeba:uinp"); + memory->create(udirp,nmax,3,"amoeba:uinp"); + if (poltyp == OPT) { + memory->create(uopt,nmax,optorder+1,3,"amoeba:uopt"); + memory->create(uoptp,nmax,optorder+1,3,"amoeba:uopt"); + memory->create(fopt,nmax,optorder,10,"amoeba:fopt"); + memory->create(foptp,nmax,optorder,10,"amoeba:foptp"); + } + memory->create(field,nmax,3,"amoeba:field"); + memory->create(fieldp,nmax,3,"amoeba:fieldp"); + memory->create(ufld,nmax,3,"amoeba:ufld"); + memory->create(dufld,nmax,6,"amoeba:dufld"); + memory->create(rsd,nmax,3,"amoeba:rsd"); + memory->create(rsdp,nmax,3,"amoeba:rsdp"); + memory->create(zrsd,nmax,3,"amoeba:zrsd"); + memory->create(zrsdp,nmax,3,"amoeba:zrsdp"); + + if (use_ewald || use_dewald) { + memory->create(thetai1,nmax,bsordermax,4,"amoeba:thetai1"); + memory->create(thetai2,nmax,bsordermax,4,"amoeba:thetai2"); + memory->create(thetai3,nmax,bsordermax,4,"amoeba:thetai3"); + memory->create(igrid,nmax,3,"amoeba:igrid"); + } + + memory->create(numneigh_dipole,nmax,"amoeba:numneigh_dipole"); + firstneigh_dipole = (int **) + memory->smalloc(nmax*sizeof(int *),"induce:firstneigh_dipole"); + firstneigh_dipdip = (double **) + memory->smalloc(nmax*sizeof(double *),"induce:firstneigh_dipdip"); + + if (poltyp == MUTUAL && pcgprec) { + memory->create(numneigh_precond,nmax,"amoeba:numneigh_precond"); + firstneigh_precond = (int **) + memory->smalloc(nmax*sizeof(int *),"induce:firstneigh_precond"); + firstneigh_pcpc = (double **) + memory->smalloc(nmax*sizeof(double *),"induce:firstneigh_pcpc"); + } +} + +// ---------------------------------------------------------------------- +// debug output methods +// ---------------------------------------------------------------------- + +/* ---------------------------------------------------------------------- + dump ID + 6 values from 2 (N,3) per-atom arrays + only proc 0 can write + file is already open +------------------------------------------------------------------------- */ + +void PairAmoeba::dump6(FILE *fp, const char *columns, double scale, + double **a, double **b) +{ + int i,j,m; + MPI_Status status; + MPI_Request request; + + // setup + + int size_one = 7; + int nlocal = atom->nlocal; + + char boundstr[9]; // encoding of boundary flags + domain->boundary_string(boundstr); + + int maxlocal; + MPI_Allreduce(&nlocal,&maxlocal,1,MPI_INT,MPI_MAX,world); + + double *buf; + memory->create(buf,maxlocal*size_one,"amoeba:buf"); + + // pack my data + + tagint *tag = atom->tag; + + m = 0; + for (i = 0; i < nlocal; i++) { + buf[m++] = tag[i]; + buf[m++] = scale*a[i][0]; + buf[m++] = scale*a[i][1]; + buf[m++] = scale*a[i][2]; + buf[m++] = scale*b[i][0]; + buf[m++] = scale*b[i][1]; + buf[m++] = scale*b[i][2]; + } + + // write file + + if (me == 0) { + fprintf(fp,"ITEM: TIMESTEP\n"); + fprintf(fp,BIGINT_FORMAT "\n",update->ntimestep); + fprintf(fp,"ITEM: NUMBER OF ATOMS\n"); + fprintf(fp,BIGINT_FORMAT "\n",atom->natoms); + fprintf(fp,"ITEM: BOX BOUNDS %s\n",boundstr); + fprintf(fp,"%-1.16e %-1.16e\n",domain->boxlo[0],domain->boxhi[0]); + fprintf(fp,"%-1.16e %-1.16e\n",domain->boxlo[1],domain->boxhi[1]); + fprintf(fp,"%-1.16e %-1.16e\n",domain->boxlo[2],domain->boxhi[2]); + fprintf(fp,"ITEM: ATOMS %s\n",columns); + } + + int nlines; + double tmp; + + if (me == 0) { + for (int iproc = 0; iproc < nprocs; iproc++) { + if (iproc) { + MPI_Irecv(buf,maxlocal*size_one,MPI_DOUBLE,iproc,0,world,&request); + MPI_Send(&tmp,0,MPI_INT,iproc,0,world); + MPI_Wait(&request,&status); + MPI_Get_count(&status,MPI_DOUBLE,&nlines); + nlines /= size_one; + } else nlines = nlocal; + + m = 0; + for (i = 0; i < nlines; i++) { + for (j = 0; j < size_one; j++) { + if (j == 0) fprintf(fp,"%d",static_cast (buf[m])); + else fprintf(fp," %g",buf[m]); + m++; + } + fprintf(fp,"\n"); + } + } + + } else { + MPI_Recv(&tmp,0,MPI_INT,0,0,world,MPI_STATUS_IGNORE); + MPI_Rsend(buf,nlocal*size_one,MPI_DOUBLE,0,0,world); + } + + // clean up + + memory->destroy(buf); +} diff --git a/src/AMOEBA/pair_amoeba.h b/src/AMOEBA/pair_amoeba.h new file mode 100644 index 0000000000..b28a00fb84 --- /dev/null +++ b/src/AMOEBA/pair_amoeba.h @@ -0,0 +1,500 @@ +/* -*- c++ -*- ---------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#ifdef PAIR_CLASS + +PairStyle(amoeba,PairAmoeba) + +#else + +#ifndef LMP_PAIR_AMOEBA_H +#define LMP_PAIR_AMOEBA_H + +#include "pair.h" +#include +#include + +#ifdef FFT_SINGLE +typedef float FFT_SCALAR; +#else +typedef double FFT_SCALAR; +#endif + +namespace LAMMPS_NS { + +#define SBBITS15 29 +#define NEIGHMASK15 0x1FFFFFFF + //#define SBBITS15 30 + //#define NEIGHMASK15 0x3FFFFFFF + +class PairAmoeba : public Pair { + public: + PairAmoeba(class LAMMPS *); + ~PairAmoeba(); + void compute(int, int); + void settings(int, char **); + void coeff(int, char **); + void init_style(); + double init_one(int, int); + + int pack_forward_comm(int, int *, double *, int, int *); + void unpack_forward_comm(int, int, double *); + int pack_reverse_comm(int, int, double *); + void unpack_reverse_comm(int, int *, double *); + + void pack_forward_grid(int, void *, int, int *); + void unpack_forward_grid(int, void *, int, int *); + void pack_reverse_grid(int, void *, int, int *); + void unpack_reverse_grid(int, void *, int, int *); + + protected: + int me,nprocs; + int nmax; // allocation for owned+ghost + int nlocalmax; // allocation for just owned + int cfstyle,crstyle; // style of forward/reverse comm operations + int nualt; + double electric; + double rotate[3][3]; // rotation matrix + + int amoeba,hippo; // which force field, only one is set + int first_flag; // 1 before first init_style() + int first_flag_compute; // 1 before first call to compute() + int optlevel; + + // turn on/off components of force field + + int hal_flag,repulse_flag,disp_flag,induce_flag,polar_flag,mpole_flag,qxfer_flag; + int rspace_flag,kspace_flag; + + // DEBUG flags + + int uind_flag; + + // DEBUG timers + + double time_init,time_hal,time_repulse,time_disp; + double time_mpole,time_induce,time_polar,time_qxfer; + + // energy, force, and virial components + + int ifhal,ifrepulse,ifdisp,ifpolar,ifmpole,ifqxfer; + double ehal,erepulse,edisp,epolar,empole,eqxfer; + double **fhal,**frepulse,**fdisp,**fpolar,**fmpole,**fqxfer; + double virhal[6],virrepulse[6],virdisp[6],virpolar[6],virmpole[6],virqxfer[6]; + + // scalar values defined in force-field file + + char *forcefield; // FF name + double am_dielectric; + + int opbendtype,vdwtype; + int radius_rule,radius_type,radius_size,epsilon_rule; + + double bond_cubic,bond_quartic; + double angle_cubic,angle_quartic,angle_pentic,angle_sextic; + double opbend_cubic,opbend_quartic,opbend_pentic,opbend_sextic; + double torsion_unit; + + int poltyp; + + double special_hal[5]; + double special_repel[5]; + double special_disp[5]; + double special_mpole[5]; + double special_polar_pscale[5]; + double special_polar_piscale[5]; + double special_polar_wscale[5]; + + double polar_dscale,polar_uscale; + + // scalar values defined in keyfile + + double dhal,ghal; + + double vdwcut,vdwtaper; + double repcut,reptaper; + double dispcut,disptaper; + double mpolecut,mpoletaper; + double ctrncut,ctrntaper; + + double ewaldcut; + double dewaldcut; + double usolvcut; + + int use_ewald,use_dewald; + + int use_pred; + int politer,polpred; + int pcgprec,pcgguess; + double pcgpeek; + int tcgnab,optorder; + int maxualt; + double poleps; + double udiag; + + int aeewald_key,apewald_key,adewald_key; + int pmegrid_key,dpmegrid_key; + + // types and classes + + int n_amtype; // # of defined AMOEBA types, 1-N + int n_amclass; // # of defined AMOEBA classes, 1-N + int max_amtype; // allocation length of per-type data + int max_amclass; // allocation length of per-class data + + int *amtype_defined; // 1 if type was defined in FF file + int *amclass_defined; // 1 if class was defined in FF file + int *amtype2class; // amt2c[i] = class which type I belongs to + + // static per-atom properties, must persist as atoms migrate + + int index_amtype,index_amgroup,index_ired; + int index_xaxis,index_yaxis,index_zaxis; + int index_polaxe,index_pval; + + int *amtype; // AMOEBA type, 1 to N_amtype + int *amgroup; // AMOEBA polarization group, 1 to Ngroup + tagint *ired; // ID of atom that H is bonded to + tagint *xaxis,*yaxis,*zaxis; // IDs of nearby atoms for multipole def + int *polaxe; + double *pval; + + char *id_pole,*id_udalt,*id_upalt; + class FixStore *fixpole; // stores pole = multipole components + class FixStore *fixudalt; // stores udalt = induced dipole history + class FixStore *fixupalt; // stores upalt = induced dipole history + + // static per-type properties defined in force-field file + + int *atomic_num; // atomic number + int *valence; // valence (# of possible bonds) + double *am_mass; // atomic weight + double *am_q; // charge + double **am_mu; // dipole moment + + double *polarity; // for polar + double *pdamp; // for polar + double *thole; // for polar + double *dirdamp; // for polar + int *npolgroup; // # of other types in polarization group, per-type + int **polgroup; // list of other types in polarization group, per-type + + double *sizpr,*dmppr,*elepr; + + // multipole frame info for each amtype, read from PRM file + + int *nmultiframe; // # of frames for each type + int **mpaxis; // polaxe values + int **xpole,**ypole,**zpole; // other types in xyz dirs for multipole frame + double ***fpole; // 13 values from file + // 0 = monopole, same as q + // 1,2,3 = 3 dipole components + // 4-12 = 9 quadrupole components + + // static per-class properties defined in force-field file + + double *vdwl_eps; // Vdwl epsilon for each class of atom + double *vdwl_sigma; // Vdwl sigma for each class of atom + double *kred; // fraction that H atoms move towards bonded atom + // used in Vdwl, 0.0 if not H atom + double *csix,*adisp; // used in dispersion + double *chgct,*dmpct; // used in charge transfer + double *pcore,*palpha; // for multipole + + int **vdwl_class_pair; // Vdwl iclass/jclass for pair of classes + double *vdwl_eps_pair; // Vdwl epsilon for pair of classes + double *vdwl_sigma_pair; // Vdwl sigma for pair of classes + int nvdwl_pair; // # of pairwise Vdwl entries in file + int max_vdwl_pair; // size of allocated data for pairwise Vdwl + + // vectors and arrays of small size + + double *copt,*copm; // 0:optorder in length + double *gear,*aspc; + + double *a_ualt,*ap_ualt; // maxualt*(maxualt+1)/2 in length + double *b_ualt,*bp_ualt; // maxualt in length + double **c_ualt,**cp_ualt; // maxualt x maxualt in size + // indices NOT flipped vs Fortran + double *bpred,*bpredp,*bpreds,*bpredps; // maxualt in length + + double vmsave[6]; // multipole virial saved to use in polar + + double csixpr; // square of csix for all atoms + + // params common to pairwise terms + + double off2,cut2; + double c0,c1,c2,c3,c4,c5; + + // Vdwl hal params - only for AMOEBA + + double **radmin,**epsilon; + double **radmin4,**epsilon4; + + // peratom values computed each step + // none of them persist with atoms + // some of them need communication to ghosts + // NOTE: allocated to nlocal or nmax? + + double **rpole; // multipole, comm to ghosts + + int *xaxis2local,*yaxis2local,*zaxis2local; // xyz axis IDs -> local indices + // just for owned atoms + // set to self if not defined + + int *ired2local; // local indices of ired IDs, computed for owned and ghost + double **xred; // altered coords for H atoms for Vdwl, comm to ghosts + + double **tq; // torque from pairwise multipole, reverse comm from ghosts + + double **uind,**uinp; // computed by induce, comm to ghosts + double **udirp; + double **rsd,**rsdp; // used by induce, comm to ghosts + + double **field,**fieldp; // used by induce, reverse comm from ghosts + double ***uopt,***uoptp; // Nlocal x Optorder+1 x 3 arrays + + double **ufld,**dufld; // used by polar, reverse comm from ghosts + double **zrsd,**zrsdp; // used by induce, reverse comm from ghosts + + double ***uad,***uap,***ubd,***ubp; // used by TCG (not for now) + + double ***fopt,***foptp; // computed in induce, used by polar, if OPT + // Nlocal x optorder x 10 + + // derived local neighbor lists + + int *numneigh_dipole; // number of dipole neighs for each atom + int **firstneigh_dipole; // ptr to each atom's dipole neigh indices + MyPage *ipage_dipole; // pages of neighbor indices for dipole neighs + + double **firstneigh_dipdip; // ptr to each atom's dip/dip values + MyPage *dpage_dipdip; // pages of dip/dip values for dipole neighs + + int *numneigh_precond; // number of precond neighs for each atom + int **firstneigh_precond; // ptr to each atom's precond neigh indices + MyPage *ipage_precond; // pages of neighbor indices for precond neighs + + double **firstneigh_pcpc; // ptr to each atom's pc/pc values + MyPage *dpage_pcpc; // pages of pc/pc values for precond neighs + + // KSpace data + // in indices = owned portion of grid in spatial decomp + // out indices = in + ghost grid cells + // fft indices = owned portion of grid in FFT decomp + + int nefft1,nefft2,nefft3; // for electrostatic PME operations + int ndfft1,ndfft2,ndfft3; // for dispersion PME operations + + int bseorder; // for electrostatics + int bsporder; // for polarization + int bsdorder; // for dispersion + int bsordermax; // max of 3 bsorder values + + double aewald; // current Ewald alpha + double aeewald; // for electrostatics + double apewald; // for polarization + double adewald; // for dispersion + + double *bsmod1,*bsmod2,*bsmod3; // B-spline module along abc axes + // set to max of any nfft1,nfft2,nfft3 + + double ***thetai1,***thetai2,***thetai3; // B-spline coeffs along abc axes + // Nlocal x max bsorder x 4 + + int **igrid; // grid indices for each owned particle, Nlocal x 3 + + double **bsbuild; // used internally in bsplgen, max-bsorder x max-bsorder + // indices ARE flipped vs Fortran + + // Kspace data for induce and polar + + double *qfac; // convoulution pre-factors + double **cmp,**fmp,**cphi,**fphi; // Cartesian and fractional multipoles + + // params for current KSpace solve and FFT being worked on + + int nfft1,nfft2,nfft3; // size of FFT + int bsorder; // stencil size + double recip[3][3]; // indices NOT flipped vs Fortran + double ctf[10][10]; // indices NOT flipped vs Fortran + double ftc[10][10]; // indices NOT flipped vs Fortran + + class AmoebaConvolution *m_kspace,*p_kspace,*pc_kspace,*d_kspace; + class AmoebaConvolution *i_kspace,*ic_kspace; + + // FFT grid size factors + + int nfactors; // # of factors + int *factors; // list of possible factors (2,3,5) + + // components of force field + + void hal(); + + void repulsion(); + void damprep(double, double, double, double, double, double, double, double, + int, double, double, double *); + + void dispersion(); + void dispersion_real(); + void dispersion_kspace(); + + void multipole(); + void multipole_real(); + void multipole_kspace(); + + void polar(); + void polar_energy(); + void polar_real(); + void polar_kspace(); + void damppole(double, int, double, double, double *, double *, double *); + + void induce(); + void ulspred(); + void ufield0c(double **, double **); + void uscale0b(int, double **, double **, double **, double **); + void dfield0c(double **, double **); + void umutual1(double **, double **); + void umutual2b(double **, double **); + void udirect1(double **); + void udirect2b(double **, double **); + void dampmut(double, double, double, double *); + void dampdir(double, double, double, double *, double *); + void cholesky(int, double *, double *); + + void charge_transfer(); + + // KSpace methods + + void lattice(); + void moduli(); + void bspline(double, int, double *); + void dftmod(double *, double *, int, int); + void bspline_fill(); + void bsplgen(double, double **); + void cmp_to_fmp(double **, double **); + void cart_to_frac(); + void fphi_to_cphi(double **, double **); + void frac_to_cart(); + + void grid_mpole(double **, double ***); + void fphi_mpole(double ***, double **); + void grid_uind(double **, double **, double ****); + void fphi_uind(double ****, double **, double **, double **); + void grid_disp(double ***); + + void kewald(); + void kewald_parallel(int, int, int, int, + int &, int &, int &, int &, int &, int &, + int &, int &, int &, int &, int &, int &, + int &, int &, int &, int &, int &, int &); + double ewaldcof(double); + int factorable(int); + + // debug methods + + FILE *fp_uind; + void dump6(FILE *, const char *, double, double **, double **); + + // functions in pair_amoeba.cpp + + void allocate(); + void print_settings(FILE *); + + void initialize_vdwl(); + void allocate_vdwl(); + void deallocate_vdwl(); + + void initialize_smallsize(); + void allocate_smallsize(); + void deallocate_smallsize(); + + void assign_groups(); + void pbc_xred(); + void precond_neigh(); + void choose(int); + void mix(); + void zero_energy_force_virial(); + void grow_local(); + + // functions in amoeba_utils.cpp + + void kmpole(); + + void chkpole(int); + void rotmat(int); + void rotsite(int); + + void add_onefive_neighbors(); + void find_hydrogen_neighbors(); + void find_multipole_neighbors(); + + void torque2force(int, double *, double *, double *, double *, double **); + + // functions in file_amoeba.cpp + + void set_defaults(); + void read_prmfile(char *); + void read_keyfile(char *); + + int read_section_name(FILE *fp, char *); + int read_section_line(FILE *fp, char *, int &, char *); + int tokenize(char *, char **&, char *&); + int count_words(const char *); + + void initialize_type_class(); + void allocate_type_class(int, int); + void deallocate_type_class(); + + void file_ffield(int, char **); + void file_literature(int, char **); + void file_atomtype(int, char **); + void file_vdwl(int, char **); + void file_vdwl_pair(int, char **); + void file_bstretch(int, char **); + void file_sbend(int, char **); + void file_abend(int, char **); + void file_pauli(int, char **); + void file_dispersion(int, char **); + void file_ub(int, char **); + void file_outplane(int, char **); + void file_torsion(int, char **); + void file_pitorsion(int, char **); + void file_multipole(int, char **); + void file_charge_penetration(int, char **); + void file_dippolar(int, char **); + void file_charge_transfer(int, char **); + + // inline function for neighbor list unmasking + + inline int sbmask15(int j) const { + return j >> SBBITS15 & 7; + } +}; + +} + +#endif +#endif + +/* ERROR/WARNING messages: + +E: Illegal ... command + +Self-explanatory. Check the input script syntax and compare to the +documentation for the command. You can use -echo screen as a +command-line option when running LAMMPS to see the offending line. + +*/ diff --git a/src/AMOEBA/pair_hippo.cpp b/src/AMOEBA/pair_hippo.cpp new file mode 100644 index 0000000000..b5af47aaaf --- /dev/null +++ b/src/AMOEBA/pair_hippo.cpp @@ -0,0 +1,24 @@ +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#include "pair_hippo.h" + +using namespace LAMMPS_NS; + +/* ---------------------------------------------------------------------- */ + +PairHippo::PairHippo(LAMMPS *lmp) : PairAmoeba(lmp) +{ + amoeba = 0; + hippo = 1; +} diff --git a/src/AMOEBA/pair_hippo.h b/src/AMOEBA/pair_hippo.h new file mode 100644 index 0000000000..da391576cb --- /dev/null +++ b/src/AMOEBA/pair_hippo.h @@ -0,0 +1,39 @@ +/* -*- c++ -*- ---------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#ifdef PAIR_CLASS + +PairStyle(hippo,PairHippo) + +#else + +#ifndef LMP_PAIR_HIPPO_H +#define LMP_PAIR_HIPPO_H + +#include "pair_amoeba.h" + +namespace LAMMPS_NS { + +class PairHippo : public PairAmoeba { + public: + PairHippo(class LAMMPS *); +}; + +} + +#endif +#endif + +/* ERROR/WARNING messages: + +*/ From 5bf13b2f3cc2c8e603f4ee20ae5cbb4c8cb4c1fb Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Wed, 25 Aug 2021 17:50:40 -0600 Subject: [PATCH 031/585] Declared victory on compute grid and grid/local --- src/ML-SNAP/compute_sna_grid_local.cpp | 11 +++++++---- src/compute_grid.cpp | 6 +----- src/compute_grid_local.cpp | 10 +++------- 3 files changed, 11 insertions(+), 16 deletions(-) diff --git a/src/ML-SNAP/compute_sna_grid_local.cpp b/src/ML-SNAP/compute_sna_grid_local.cpp index 18d9f5496d..c1574bfa26 100644 --- a/src/ML-SNAP/compute_sna_grid_local.cpp +++ b/src/ML-SNAP/compute_sna_grid_local.cpp @@ -272,17 +272,20 @@ void ComputeSNAGridLocal::compute_local() // linear contributions for (int icoeff = 0; icoeff < ncoeff; icoeff++) - gridlocal[size_local_cols_base+icoeff][iz][iy][ix] = snaptr->blist[icoeff]; - + gridlocal[size_local_cols_base+icoeff][iz][iy][ix] = + snaptr->blist[icoeff]; + // quadratic contributions if (quadraticflag) { int ncount = ncoeff; for (int icoeff = 0; icoeff < ncoeff; icoeff++) { double bveci = snaptr->blist[icoeff]; - gridlocal[size_local_cols_base+ncount++][iz][iy][ix] = 0.5*bveci*bveci; + gridlocal[size_local_cols_base+ncount++][iz][iy][ix] = + 0.5*bveci*bveci; for (int jcoeff = icoeff+1; jcoeff < ncoeff; jcoeff++) - gridlocal[size_local_cols_base+ncount++][iz][iy][ix] = bveci*snaptr->blist[jcoeff]; + gridlocal[size_local_cols_base+ncount++][iz][iy][ix] = + bveci*snaptr->blist[jcoeff]; } } } diff --git a/src/compute_grid.cpp b/src/compute_grid.cpp index 0d880b94d5..7eee793023 100644 --- a/src/compute_grid.cpp +++ b/src/compute_grid.cpp @@ -207,11 +207,7 @@ void ComputeGrid::allocate() memory->destroy(local_flags); if (gridlocal_allocated) { gridlocal_allocated = 0; - // MEMORY LEAK!! - // can't seem to free this memory without seg-fault - // printf("Before allocate destroy4d, proc %d %p\n",comm->me,gridlocal); - // memory->destroy4d_offset(gridlocal,nzlo,nylo,nxlo); - // printf("After allocate destroy4d, proc %d %p\n",comm->me,gridlocal); + memory->destroy4d_offset(gridlocal,nzlo,nylo,nxlo); } memory->create(grid,size_array_rows,size_array_cols,"grid:grid"); diff --git a/src/compute_grid_local.cpp b/src/compute_grid_local.cpp index 8c0f8ff066..dab9aa44d4 100644 --- a/src/compute_grid_local.cpp +++ b/src/compute_grid_local.cpp @@ -104,16 +104,12 @@ void ComputeGridLocal::allocate() if (gridlocal_allocated) { gridlocal_allocated = 0; - // MEMORY LEAK!! - // can't seem to free this memory without seg-fault - // printf("Before allocate destroy4d, proc %d %p\n",comm->me,gridlocal); - // memory->destroy4d_offset(gridlocal,nzlo,nylo,nxlo); - // printf("After allocate destroy4d, proc %d %p\n",comm->me,gridlocal); + memory->destroy4d_offset(gridlocal,nzlo,nylo,nxlo); } if (nxlo <= nxhi && nylo <= nyhi && nzlo <= nzhi) { gridlocal_allocated = 1; - memory->create4d_offset(gridlocal,size_array_cols,nzlo,nzhi,nylo,nyhi, + memory->create4d_offset(gridlocal,size_local_cols,nzlo,nzhi,nylo,nyhi, nxlo,nxhi,"grid:gridlocal"); } } @@ -248,6 +244,6 @@ void ComputeGridLocal::copy_gridlocal_to_local_array() double ComputeGridLocal::memory_usage() { - int nbytes = size_array_cols*ngridlocal*sizeof(double); // gridlocal + int nbytes = size_local_cols*ngridlocal*sizeof(double); // gridlocal return nbytes; } From 78f9c7b47818dcffc6c89ecdeb9e8d1cb8df85a0 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Wed, 25 Aug 2021 17:52:53 -0600 Subject: [PATCH 032/585] Declared victory on compute grid and grid/local --- examples/snap/in.grid.local | 4 ++++ 1 file changed, 4 insertions(+) diff --git a/examples/snap/in.grid.local b/examples/snap/in.grid.local index dc04fd5371..121f0ba981 100644 --- a/examples/snap/in.grid.local +++ b/examples/snap/in.grid.local @@ -71,3 +71,7 @@ dump mydump_bgridlocal all local 1000 dump_bgridlocal index c_mygridlocal[*] run 0 +run 0 + +run 0 + From ea3c89165a14565351d49b25fb14043b9f9a1649 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Thu, 26 Aug 2021 11:52:06 -0600 Subject: [PATCH 033/585] Resolved memory management issue exposed by RCB in in.grid.test --- examples/snap/in.grid.test | 105 +++++++++++++++++++++++++++++++++++++ 1 file changed, 105 insertions(+) create mode 100644 examples/snap/in.grid.test diff --git a/examples/snap/in.grid.test b/examples/snap/in.grid.test new file mode 100644 index 0000000000..c684200d44 --- /dev/null +++ b/examples/snap/in.grid.test @@ -0,0 +1,105 @@ +# Demonstrate bispectrum computes + +# CORRECTNESS: thermo output for c_mygrid[*][1] and c_mygrid[*][8] should +# match the values in dump_b: 108.173 3.21778 0.712238 7.06634 1.04273 + +# Initialize simulation + +variable nsteps index 0 +variable nrep index 3 +variable a index 3.316 +variable ngrid index 2 + +units metal + +atom_modify map yes + +# generate the box and atom positions using a BCC lattice + +variable nx equal ${nrep} +variable ny equal ${nrep} +variable nz equal ${nrep} + +boundary p p p + +lattice custom $a & + a1 1 0 0 & + a2 0 1 0 & + a3 0 0 1 & + basis 0 0 0 & + basis 0.5 0.5 0.5 & +# origin 0.25 0.25 0.25 +# origin 0.25e-3 0.25e-3 0.25e-3 + +region box block 0 ${nx} 0 ${ny} 0 ${nz} +create_box 1 box +create_atoms 1 box + +mass 1 180.88 + +write_dump all custom test.dump id type x y z + +# choose potential + +include Ta06A.snap + +# define grid compute and atom compute + +group snapgroup type 1 +variable twojmax equal 2 +variable rcutfac equal 4.67637 +variable rfac0 equal 0.99363 +variable rmin0 equal 0 +variable wj equal 1 +variable radelem equal 0.5 +variable bzero equal 0 +variable quad equal 0 +variable switch equal 1 + +compute b all sna/atom & + ${rcutfac} ${rfac0} ${twojmax} ${radelem} & + ${wj} rmin0 ${rmin0} bzeroflag ${bzero} & + quadraticflag ${quad} switchflag ${switch} + +compute mygrid all sna/grid grid ${ngrid} ${ngrid} ${ngrid} & + ${rcutfac} ${rfac0} ${twojmax} ${radelem} & + ${wj} rmin0 ${rmin0} bzeroflag ${bzero} & + quadraticflag ${quad} switchflag ${switch} + +compute mygridlocal all sna/grid/local grid ${ngrid} ${ngrid} ${ngrid} & + ${rcutfac} ${rfac0} ${twojmax} ${radelem} & + ${wj} rmin0 ${rmin0} bzeroflag ${bzero} & + quadraticflag ${quad} switchflag ${switch} + +# define output + +# mygrid is ngrid by (3+nbis) = 8x8 +thermo_style custom step temp ke pe vol & + c_mygrid[1][1] c_mygrid[2][1] c_mygrid[3][1] c_mygrid[4][1] c_mygrid[5][1] c_mygrid[6][1] c_mygrid[7][1] c_mygrid[8][1] & + c_mygrid[1][2] c_mygrid[2][2] c_mygrid[3][2] c_mygrid[4][2] c_mygrid[5][2] c_mygrid[6][2] c_mygrid[7][2] c_mygrid[8][2] & + c_mygrid[1][3] c_mygrid[2][3] c_mygrid[3][3] c_mygrid[4][3] c_mygrid[5][3] c_mygrid[6][3] c_mygrid[7][3] c_mygrid[8][3] & + c_mygrid[1][4] c_mygrid[2][4] c_mygrid[3][4] c_mygrid[4][4] c_mygrid[5][4] c_mygrid[6][4] c_mygrid[7][4] c_mygrid[8][4] & + c_mygrid[1][5] c_mygrid[2][5] c_mygrid[3][5] c_mygrid[4][5] c_mygrid[5][5] c_mygrid[6][5] c_mygrid[7][5] c_mygrid[8][5] & + c_mygrid[1][6] c_mygrid[2][6] c_mygrid[3][6] c_mygrid[4][6] c_mygrid[5][6] c_mygrid[6][6] c_mygrid[7][6] c_mygrid[8][6] & + c_mygrid[1][7] c_mygrid[2][7] c_mygrid[3][7] c_mygrid[4][7] c_mygrid[5][7] c_mygrid[6][7] c_mygrid[7][7] c_mygrid[8][7] & + c_mygrid[1][8] c_mygrid[2][8] c_mygrid[3][8] c_mygrid[4][8] c_mygrid[5][8] c_mygrid[6][8] c_mygrid[7][8] c_mygrid[8][8] +thermo_modify norm yes + +#dump mydump_b all custom 1 dump_b id c_b[*] +dump mydump_bgridlocal all local 1 dump_bgridlocal index c_mygridlocal[*] + +# run + +run 1 + +# rcb + +comm_style tiled +balance 0.99 rcb +run 1 + +# rcb again + +balance 0.99 rcb +run 1 + From db58cec057e7b790bd706ad63c28c3ff79473d7f Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Thu, 26 Aug 2021 11:52:46 -0600 Subject: [PATCH 034/585] Resolved memory management issue exposed by RCB in in.grid.test --- src/compute_grid.cpp | 36 +++++++++++++++++--------------- src/compute_grid.h | 3 ++- src/compute_grid_local.cpp | 42 +++++++++++++++++++++++--------------- src/compute_grid_local.h | 4 +++- 4 files changed, 51 insertions(+), 34 deletions(-) diff --git a/src/compute_grid.cpp b/src/compute_grid.cpp index 7eee793023..52bd7d6307 100644 --- a/src/compute_grid.cpp +++ b/src/compute_grid.cpp @@ -60,13 +60,7 @@ ComputeGrid::ComputeGrid(LAMMPS *lmp, int narg, char **arg) : ComputeGrid::~ComputeGrid() { - memory->destroy(grid); - memory->destroy(gridall); - memory->destroy(local_flags); - if (gridlocal_allocated) { - gridlocal_allocated = 0; - memory->destroy4d_offset(gridlocal,nzlo,nylo,nxlo); - } + deallocate(); } /* ---------------------------------------------------------------------- */ @@ -79,6 +73,7 @@ void ComputeGrid::init() void ComputeGrid::setup() { + deallocate(); set_grid_global(); set_grid_local(); allocate(); @@ -195,21 +190,13 @@ void ComputeGrid::assign_local_flags() } /* ---------------------------------------------------------------------- - free and reallocate arrays + create arrays ------------------------------------------------------------------------- */ void ComputeGrid::allocate() { // allocate arrays - memory->destroy(grid); - memory->destroy(gridall); - memory->destroy(local_flags); - if (gridlocal_allocated) { - gridlocal_allocated = 0; - memory->destroy4d_offset(gridlocal,nzlo,nylo,nxlo); - } - memory->create(grid,size_array_rows,size_array_cols,"grid:grid"); memory->create(gridall,size_array_rows,size_array_cols,"grid:gridall"); memory->create(local_flags,size_array_rows,"grid:local_flags"); @@ -222,6 +209,23 @@ void ComputeGrid::allocate() } +/* ---------------------------------------------------------------------- + free arrays +------------------------------------------------------------------------- */ + +void ComputeGrid::deallocate() +{ + memory->destroy(grid); + memory->destroy(gridall); + memory->destroy(local_flags); + if (gridlocal_allocated) { + gridlocal_allocated = 0; + memory->destroy4d_offset(gridlocal,nzlo,nylo,nxlo); + } + array = nullptr; +} + + /* ---------------------------------------------------------------------- set global grid ------------------------------------------------------------------------- */ diff --git a/src/compute_grid.h b/src/compute_grid.h index 1b2797732d..421656febf 100644 --- a/src/compute_grid.h +++ b/src/compute_grid.h @@ -49,7 +49,8 @@ class ComputeGrid : public Compute { int *local_flags; // local flag for each grid point int gridlocal_allocated; // shows if gridlocal allocated - void allocate(); + void allocate(); // create arrays + void deallocate(); // free arrays void grid2x(int, double*); // convert grid point to coord void grid2ix(int, int&, int&, int&); // convert grid point to ix, iy, iz void assign_coords(); // assign coords for grid diff --git a/src/compute_grid_local.cpp b/src/compute_grid_local.cpp index dab9aa44d4..1b8de3c48a 100644 --- a/src/compute_grid_local.cpp +++ b/src/compute_grid_local.cpp @@ -59,11 +59,7 @@ ComputeGridLocal::ComputeGridLocal(LAMMPS *lmp, int narg, char **arg) : ComputeGridLocal::~ComputeGridLocal() { - if (gridlocal_allocated) { - gridlocal_allocated = 0; - memory->destroy4d_offset(gridlocal,nzlo,nylo,nxlo); - } - memory->destroy(alocal); + deallocate(); } /* ---------------------------------------------------------------------- */ @@ -76,9 +72,11 @@ void ComputeGridLocal::init() void ComputeGridLocal::setup() { + deallocate(); set_grid_global(); set_grid_local(); allocate(); + assign_coords(); } /* ---------------------------------------------------------------------- @@ -95,25 +93,34 @@ void ComputeGridLocal::grid2x(int ix, int iy, int iz, double *x) } /* ---------------------------------------------------------------------- - free and reallocate arrays + create arrays ------------------------------------------------------------------------- */ void ComputeGridLocal::allocate() { - // allocate local array - - if (gridlocal_allocated) { - gridlocal_allocated = 0; - memory->destroy4d_offset(gridlocal,nzlo,nylo,nxlo); - } - if (nxlo <= nxhi && nylo <= nyhi && nzlo <= nzhi) { gridlocal_allocated = 1; memory->create4d_offset(gridlocal,size_local_cols,nzlo,nzhi,nylo,nyhi, nxlo,nxhi,"grid:gridlocal"); + memory->create(alocal, size_local_rows, size_local_cols, "compute/grid/local:alocal"); + array_local = alocal; } } +/* ---------------------------------------------------------------------- + free arrays +------------------------------------------------------------------------- */ + +void ComputeGridLocal::deallocate() +{ + if (gridlocal_allocated) { + gridlocal_allocated = 0; + memory->destroy4d_offset(gridlocal,nzlo,nylo,nxlo); + memory->destroy(alocal); + } + array_local = nullptr; +} + /* ---------------------------------------------------------------------- set global grid ------------------------------------------------------------------------- */ @@ -201,11 +208,14 @@ void ComputeGridLocal::set_grid_local() ngridlocal = (nxhi - nxlo + 1) * (nyhi - nylo + 1) * (nzhi - nzlo + 1); size_local_rows = ngridlocal; +} - memory->destroy(alocal); - memory->create(alocal, size_local_rows, size_local_cols, "compute/grid/local:alocal"); - array_local = alocal; +/* ---------------------------------------------------------------------- + copy coords to local array +------------------------------------------------------------------------- */ +void ComputeGridLocal::assign_coords() +{ int igrid = 0; for (int iz = nzlo; iz <= nzhi; iz++) for (int iy = nylo; iy <= nyhi; iy++) diff --git a/src/compute_grid_local.h b/src/compute_grid_local.h index b6cd882b2e..6189e5b27d 100644 --- a/src/compute_grid_local.h +++ b/src/compute_grid_local.h @@ -46,10 +46,12 @@ class ComputeGridLocal : public Compute { int size_local_cols_base; // number of columns used for coords, etc. int gridlocal_allocated; // shows if gridlocal allocated - void allocate(); + void allocate(); // create arrays + void deallocate(); // free arrays void grid2x(int, int, int, double*); // convert global indices to coordinates void set_grid_global(); // set global grid void set_grid_local(); // set bounds for local grid + void assign_coords(); // assign coords for grid void copy_gridlocal_to_local_array();// copy 4d gridlocal array to 2d local array private: }; From 0a4e85a1f35c029b920246980ad0d1cfa4c42988 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Thu, 26 Aug 2021 11:58:39 -0600 Subject: [PATCH 035/585] Added README.grid --- examples/snap/README.grid | 9 +++++++++ 1 file changed, 9 insertions(+) create mode 100644 examples/snap/README.grid diff --git a/examples/snap/README.grid b/examples/snap/README.grid new file mode 100644 index 0000000000..9033c9d445 --- /dev/null +++ b/examples/snap/README.grid @@ -0,0 +1,9 @@ +This branch contains the following examples: + +in.grid # simple example of grid +in.grid.local # simple example of grid/local +in.grid.python # used by grid.py +in.grid.test # stress test of grid and grid/local +in.grid.tri # grid with triclinic cell + +grid.py # access data from Python library interface From 9f460712268a65141ab5da0f29e06a0aef7a7819 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Thu, 26 Aug 2021 15:09:27 -0600 Subject: [PATCH 036/585] fix example problems --- examples/amoeba/data.water_box.amoeba | 1980 +++++++++++++++++ examples/amoeba/data.water_box.hippo | 1980 +++++++++++++++++ examples/amoeba/data.water_dimer.amoeba | 18 +- examples/amoeba/data.water_dimer.hippo | 18 +- examples/amoeba/data.water_hexamer.amoeba | 42 +- examples/amoeba/data.water_hexamer.hippo | 42 +- examples/amoeba/in.ubiquitin | 11 +- .../{in.water_box => in.water_box.amoeba} | 15 +- examples/amoeba/in.water_box.hippo | 45 + .../{in.water_dimer => in.water_dimer.amoeba} | 15 +- examples/amoeba/in.water_dimer.hippo | 45 + ....water_hexamer => in.water_hexamer.amoeba} | 15 +- examples/amoeba/in.water_hexamer.hippo | 45 + src/fix_property_atom.cpp | 2 +- 14 files changed, 4196 insertions(+), 77 deletions(-) create mode 100644 examples/amoeba/data.water_box.amoeba create mode 100644 examples/amoeba/data.water_box.hippo rename examples/amoeba/{in.water_box => in.water_box.amoeba} (68%) create mode 100644 examples/amoeba/in.water_box.hippo rename examples/amoeba/{in.water_dimer => in.water_dimer.amoeba} (68%) create mode 100644 examples/amoeba/in.water_dimer.hippo rename examples/amoeba/{in.water_hexamer => in.water_hexamer.amoeba} (69%) create mode 100644 examples/amoeba/in.water_hexamer.hippo diff --git a/examples/amoeba/data.water_box.amoeba b/examples/amoeba/data.water_box.amoeba new file mode 100644 index 0000000000..6f513c0234 --- /dev/null +++ b/examples/amoeba/data.water_box.amoeba @@ -0,0 +1,1980 @@ +LAMMPS data file created from Tinker watersmall.xyz and amoeba.prm files + +648 atoms +432 bonds +216 angles +2 atom types +1 bond types +1 angle types +-9.869157 9.999917 xlo xhi +-10.006163 10.191392 ylo yhi +-9.986525 10.056536 zlo zhi + +Masses + +1 15.995 +2 1.008 + +Atoms + +1 1 1 0 8.679662 7.087692 -0.696862 +2 1 2 0 7.809455 6.755792 -0.382259 +3 1 2 0 8.722232 6.814243 -1.617561 +4 2 1 0 -0.117313 8.244447 6.837616 +5 2 2 0 0.216892 7.895445 6.050027 +6 2 2 0 0.444268 7.826013 7.530196 +7 3 1 0 8.379057 -0.092611 6.814631 +8 3 2 0 9.340423 0.098069 6.734062 +9 3 2 0 7.939619 0.573676 6.269838 +10 4 1 0 6.589952 1.844323 -6.923167 +11 4 2 0 5.885429 2.402305 -6.717934 +12 4 2 0 6.181533 1.062747 -7.273678 +13 5 1 0 7.146600 5.753582 2.331517 +14 5 2 0 6.368123 6.126035 2.862678 +15 5 2 0 7.025018 6.294645 1.518196 +16 6 1 0 -2.426581 -8.504195 -2.504834 +17 6 2 0 -1.692063 -8.368252 -3.058292 +18 6 2 0 -2.793207 -7.602469 -2.403097 +19 7 1 0 -8.038375 -3.605589 2.303691 +20 7 2 0 -8.113753 -4.248127 3.018494 +21 7 2 0 -7.619392 -2.863004 2.709622 +22 8 1 0 -1.480631 8.244085 -8.272215 +23 8 2 0 -2.090204 8.687978 -7.676996 +24 8 2 0 -0.700878 8.823325 -8.322213 +25 9 1 0 -3.741962 -2.777830 -2.326319 +26 9 2 0 -4.620456 -2.444778 -2.390519 +27 9 2 0 -3.728921 -3.160952 -1.433101 +28 10 1 0 -6.467812 -5.265942 0.408263 +29 10 2 0 -6.585076 -4.796537 -0.413008 +30 10 2 0 -7.021252 -4.752640 1.007958 +31 11 1 0 9.273577 5.342431 4.055460 +32 11 2 0 8.645939 5.466500 4.837640 +33 11 2 0 8.741774 5.686149 3.302820 +34 12 1 0 1.830160 4.276731 -6.993499 +35 12 2 0 1.703275 5.223773 -6.703852 +36 12 2 0 2.408113 3.853447 -6.383339 +37 13 1 0 1.964382 6.832988 8.373101 +38 13 2 0 2.496135 7.215781 9.056298 +39 13 2 0 1.811283 5.905846 8.573539 +40 14 1 0 5.405568 4.388994 7.932737 +41 14 2 0 5.537380 3.438955 7.781311 +42 14 2 0 4.755156 4.734908 7.290617 +43 15 1 0 3.229998 2.928417 -1.090650 +44 15 2 0 3.931090 3.198265 -1.702769 +45 15 2 0 3.004438 3.708969 -0.493266 +46 16 1 0 7.462400 5.262829 6.131170 +47 16 2 0 8.025650 5.588493 6.881770 +48 16 2 0 6.935076 4.455766 6.325405 +49 17 1 0 -8.864042 7.023845 -6.659632 +50 17 2 0 -8.370939 6.372557 -7.141895 +51 17 2 0 -9.489800 7.315873 -7.293125 +52 18 1 0 -4.526299 3.549989 8.030031 +53 18 2 0 -5.169770 4.224127 7.731323 +54 18 2 0 -4.262096 3.801892 8.884875 +55 19 1 0 4.823286 -1.386218 4.038464 +56 19 2 0 5.493155 -0.669965 4.013081 +57 19 2 0 4.187463 -1.101832 3.338433 +58 20 1 0 -2.151150 -2.017060 -8.593685 +59 20 2 0 -2.475709 -2.320356 -7.783564 +60 20 2 0 -2.650484 -2.434614 -9.307384 +61 21 1 0 1.944893 4.933226 0.497910 +62 21 2 0 2.553221 5.263352 1.205303 +63 21 2 0 2.082534 5.590999 -0.202171 +64 22 1 0 -6.827006 -5.285917 -2.371899 +65 22 2 0 -7.405873 -6.022738 -2.075913 +66 22 2 0 -6.398443 -5.453726 -3.235054 +67 23 1 0 -8.538047 -7.577917 -1.688532 +68 23 2 0 -8.075591 -8.448260 -1.513455 +69 23 2 0 -9.389507 -7.836271 -2.051835 +70 24 1 0 -6.916556 -1.100882 -5.168782 +71 24 2 0 -6.365888 -1.659366 -5.746210 +72 24 2 0 -6.538885 -0.249374 -5.325993 +73 25 1 0 6.330290 -9.323893 -6.416630 +74 25 2 0 7.026026 -9.680578 -7.007727 +75 25 2 0 6.812488 -8.683594 -5.925799 +76 26 1 0 -2.424345 -5.918126 2.701855 +77 26 2 0 -1.613829 -5.486394 2.503024 +78 26 2 0 -3.144797 -5.307275 2.618121 +79 27 1 0 0.637202 -6.080457 5.849135 +80 27 2 0 0.892312 -6.092342 4.907709 +81 27 2 0 -0.339074 -5.838972 5.853292 +82 28 1 0 5.199216 -2.264918 -0.138343 +83 28 2 0 5.802838 -2.788698 -0.697536 +84 28 2 0 5.670340 -1.679393 0.462296 +85 29 1 0 0.510145 7.629450 4.054500 +86 29 2 0 -0.071135 8.146563 3.452959 +87 29 2 0 1.464962 7.740819 3.669172 +88 30 1 0 3.146724 8.895843 6.526257 +89 30 2 0 3.506091 8.599906 7.352942 +90 30 2 0 2.145729 8.929622 6.682029 +91 31 1 0 7.308541 -8.339335 -2.471342 +92 31 2 0 6.562127 -8.180601 -3.062803 +93 31 2 0 6.993025 -8.364954 -1.531235 +94 32 1 0 -7.530792 1.069683 4.989387 +95 32 2 0 -7.565406 1.971422 4.648636 +96 32 2 0 -7.938250 0.433547 4.370266 +97 33 1 0 4.452035 2.700609 -5.437815 +98 33 2 0 4.603326 3.058652 -4.551590 +99 33 2 0 4.386453 1.737004 -5.180419 +100 34 1 0 8.427922 -8.619286 1.784691 +101 34 2 0 8.340498 -8.005342 2.536225 +102 34 2 0 8.496720 -9.530562 2.174667 +103 35 1 0 -8.109456 1.753830 -3.096997 +104 35 2 0 -7.245287 1.827177 -2.721417 +105 35 2 0 -8.082178 1.783171 -4.059329 +106 36 1 0 2.776933 -5.701955 7.748213 +107 36 2 0 3.287974 -5.069688 7.233816 +108 36 2 0 1.987041 -5.817355 7.200131 +109 37 1 0 3.635171 -6.953519 5.339628 +110 37 2 0 3.353851 -7.592789 6.031367 +111 37 2 0 2.875801 -6.787975 4.740576 +112 38 1 0 6.888027 -4.169023 -1.800190 +113 38 2 0 7.559735 -4.813701 -2.004669 +114 38 2 0 6.603805 -3.759237 -2.626496 +115 39 1 0 -4.470837 -4.105640 3.415362 +116 39 2 0 -4.991607 -3.358538 3.140956 +117 39 2 0 -4.791764 -4.392214 4.254387 +118 40 1 0 8.282263 -0.462068 -2.560579 +119 40 2 0 8.776769 -1.293641 -2.335945 +120 40 2 0 8.760297 0.384816 -2.651128 +121 41 1 0 4.737236 1.616430 4.901115 +122 41 2 0 3.969692 2.168368 5.152631 +123 41 2 0 5.184651 2.148403 4.154746 +124 42 1 0 -3.497332 -5.781436 -2.202713 +125 42 2 0 -4.038857 -5.773824 -1.381680 +126 42 2 0 -4.152970 -6.012265 -2.829379 +127 43 1 0 -2.863989 -0.259334 -1.857006 +128 43 2 0 -2.132201 -0.027953 -1.174211 +129 43 2 0 -2.873625 -1.224425 -1.874253 +130 44 1 0 1.138300 1.133100 -2.085899 +131 44 2 0 1.965506 1.503520 -1.725316 +132 44 2 0 0.420521 1.534440 -1.551356 +133 45 1 0 -0.561328 4.590705 -2.780017 +134 45 2 0 -0.061173 3.919356 -3.294128 +135 45 2 0 -0.082763 4.733898 -1.955602 +136 46 1 0 -6.423002 -1.705204 -2.528225 +137 46 2 0 -7.233989 -1.949552 -1.975418 +138 46 2 0 -6.678416 -1.321413 -3.351278 +139 47 1 0 -2.772100 2.552210 -0.672282 +140 47 2 0 -2.907489 3.483552 -0.385605 +141 47 2 0 -2.977127 2.592348 -1.635820 +142 48 1 0 6.708678 -4.852016 -8.379280 +143 48 2 0 6.593474 -5.094964 -7.447187 +144 48 2 0 6.582524 -5.591596 -8.966502 +145 49 1 0 -8.497001 -0.440284 2.803721 +146 49 2 0 -8.422350 0.331961 2.183451 +147 49 2 0 -9.377295 -0.756160 2.677026 +148 50 1 0 2.975383 -0.894970 6.060783 +149 50 2 0 2.093991 -0.995700 5.670129 +150 50 2 0 3.458832 -0.759248 5.263958 +151 51 1 0 -6.085023 -1.629620 7.970284 +152 51 2 0 -6.685848 -2.391830 7.820849 +153 51 2 0 -6.177296 -1.190584 8.835912 +154 52 1 0 -3.763523 -3.356777 8.285436 +155 52 2 0 -4.660650 -3.029414 8.406662 +156 52 2 0 -3.411834 -3.178947 7.431180 +157 53 1 0 -1.100120 -0.320162 0.375372 +158 53 2 0 -0.527013 -1.012183 0.128652 +159 53 2 0 -0.673226 0.288559 0.934677 +160 54 1 0 0.910209 -8.271802 1.411429 +161 54 2 0 0.158544 -8.759532 1.870895 +162 54 2 0 0.565924 -7.546113 0.944383 +163 55 1 0 1.554065 -6.468033 3.310872 +164 55 2 0 1.362455 -7.162802 2.722340 +165 55 2 0 1.616233 -5.622409 2.872854 +166 56 1 0 0.543127 -1.388652 4.886094 +167 56 2 0 0.110320 -0.665826 5.311239 +168 56 2 0 0.420366 -2.216367 5.267301 +169 57 1 0 1.100526 1.019490 -9.255318 +170 57 2 0 1.460815 0.575286 -8.484128 +171 57 2 0 0.265613 0.594128 -9.297750 +172 58 1 0 -1.842348 2.327827 -5.355326 +173 58 2 0 -1.572941 2.573139 -6.288125 +174 58 2 0 -2.216679 1.439934 -5.361006 +175 59 1 0 2.452307 -2.814686 -6.448759 +176 59 2 0 2.862295 -3.091668 -5.589336 +177 59 2 0 2.913920 -3.262923 -7.181510 +178 60 1 0 -2.207998 -3.112007 5.945795 +179 60 2 0 -1.262203 -3.125339 6.205467 +180 60 2 0 -2.228269 -2.421858 5.220629 +181 61 1 0 5.845471 5.020556 -6.836491 +182 61 2 0 5.557986 5.913737 -6.753889 +183 61 2 0 5.089998 4.459153 -6.661079 +184 62 1 0 -3.421643 4.865553 0.731755 +185 62 2 0 -3.965419 4.458452 1.478214 +186 62 2 0 -3.973445 4.958338 -0.044430 +187 63 1 0 -2.302950 -2.349717 2.112168 +188 63 2 0 -2.576438 -1.873492 2.873191 +189 63 2 0 -1.882868 -1.715106 1.503782 +190 64 1 0 0.305885 4.878766 3.791182 +191 64 2 0 0.299338 5.855407 4.097578 +192 64 2 0 1.169911 4.563497 4.030616 +193 65 1 0 2.925008 -3.664845 -3.607450 +194 65 2 0 3.015896 -3.916618 -2.644267 +195 65 2 0 2.353923 -2.889459 -3.518284 +196 66 1 0 1.111505 -4.070255 -9.085693 +197 66 2 0 2.084905 -4.227348 -9.180249 +198 66 2 0 0.897072 -4.902218 -8.740523 +199 67 1 0 -4.992929 -1.974219 -7.099668 +200 67 2 0 -5.173269 -1.186309 -7.673625 +201 67 2 0 -5.070893 -2.753273 -7.658821 +202 68 1 0 4.730983 1.478420 0.720986 +203 68 2 0 4.271686 1.988265 0.034225 +204 68 2 0 4.117413 0.788607 1.061818 +205 69 1 0 1.421583 -0.176666 -6.729105 +206 69 2 0 1.217660 0.394331 -5.978213 +207 69 2 0 1.948444 -0.877988 -6.400659 +208 70 1 0 -7.093223 -8.541193 4.116187 +209 70 2 0 -7.074252 -8.047477 3.242159 +210 70 2 0 -6.153142 -8.537148 4.455550 +211 71 1 0 8.382540 -6.460958 3.765735 +212 71 2 0 9.258625 -6.141972 4.060763 +213 71 2 0 7.637364 -6.217910 4.407852 +214 72 1 0 -4.320241 4.037137 3.297092 +215 72 2 0 -3.750151 4.141786 4.105470 +216 72 2 0 -5.172925 4.455578 3.488906 +217 73 1 0 5.581877 1.781994 7.505132 +218 73 2 0 5.017196 1.139584 8.120950 +219 73 2 0 5.330781 1.591217 6.595286 +220 74 1 0 -0.734443 1.125031 4.884666 +221 74 2 0 -0.239224 1.540322 4.142070 +222 74 2 0 -0.961628 1.783437 5.554548 +223 75 1 0 6.831005 -9.249970 4.497165 +224 75 2 0 6.836746 -9.068011 5.427146 +225 75 2 0 7.668067 -9.652510 4.249957 +226 76 1 0 2.714055 -3.677581 1.962003 +227 76 2 0 3.333432 -3.851775 2.663540 +228 76 2 0 3.095021 -3.978526 1.102566 +229 77 1 0 -1.364034 -5.762724 -5.514747 +230 77 2 0 -2.238584 -5.409106 -5.314718 +231 77 2 0 -0.948185 -4.908428 -5.559580 +232 78 1 0 -3.623435 -8.061229 1.383141 +233 78 2 0 -3.132847 -7.446722 1.857906 +234 78 2 0 -4.307943 -7.546630 0.933298 +235 79 1 0 5.717894 6.958376 4.528556 +236 79 2 0 5.852657 7.879846 4.341790 +237 79 2 0 6.443636 6.708413 5.135144 +238 80 1 0 8.121415 8.262619 -8.483986 +239 80 2 0 8.585190 8.939651 -8.974230 +240 80 2 0 7.560207 7.748539 -9.044644 +241 81 1 0 -5.111889 -0.352865 5.807903 +242 81 2 0 -5.940048 0.102298 5.569630 +243 81 2 0 -5.349104 -1.014090 6.507582 +244 82 1 0 0.327324 2.563438 0.113251 +245 82 2 0 -0.633994 2.522136 -0.069385 +246 82 2 0 0.724331 3.482989 0.160564 +247 83 1 0 -6.003367 -7.683112 -8.874252 +248 83 2 0 -6.987751 -7.912403 -8.892689 +249 83 2 0 -5.699015 -8.504722 -8.558813 +250 84 1 0 0.789377 -6.357883 -7.563043 +251 84 2 0 -0.151101 -6.341313 -7.440906 +252 84 2 0 1.090881 -5.879281 -6.770796 +253 85 1 0 5.045666 7.219298 -5.151826 +254 85 2 0 5.598994 7.846492 -5.618276 +255 85 2 0 5.480466 6.978976 -4.337211 +256 86 1 0 1.286092 6.990271 -6.806004 +257 86 2 0 0.481329 7.140371 -7.345224 +258 86 2 0 1.716012 7.791024 -6.762706 +259 87 1 0 -3.198783 -9.175883 -6.334156 +260 87 2 0 -3.032721 -8.198157 -6.198635 +261 87 2 0 -3.084774 -9.539992 -5.434969 +262 88 1 0 -2.002554 -5.668583 5.440781 +263 88 2 0 -2.347493 -4.756386 5.542471 +264 88 2 0 -2.133027 -6.049986 4.540349 +265 89 1 0 6.174952 -8.574733 0.210584 +266 89 2 0 5.358389 -8.191902 0.557392 +267 89 2 0 6.760918 -8.561710 0.943985 +268 90 1 0 -6.278610 6.057339 4.042358 +269 90 2 0 -6.169211 6.708022 3.383078 +270 90 2 0 -7.221766 5.771239 4.032205 +271 91 1 0 0.124733 -5.816398 0.203961 +272 91 2 0 0.029974 -5.049468 0.786871 +273 91 2 0 -0.458026 -5.646677 -0.555312 +274 92 1 0 3.839311 -0.064469 8.619720 +275 92 2 0 3.586253 -0.282978 7.705313 +276 92 2 0 3.079936 0.282626 9.065559 +277 93 1 0 7.375986 -1.368885 4.452411 +278 93 2 0 8.024931 -0.682735 4.768078 +279 93 2 0 7.477247 -1.279372 3.493009 +280 94 1 0 9.209092 -1.611532 -6.423337 +281 94 2 0 9.487648 -2.470973 -6.800897 +282 94 2 0 9.998917 -1.354277 -5.866779 +283 95 1 0 -5.314625 -5.613762 7.941745 +284 95 2 0 -5.589748 -6.389969 8.478078 +285 95 2 0 -4.444519 -5.357513 8.149460 +286 96 1 0 -3.655884 2.941259 -3.295211 +287 96 2 0 -4.418712 2.528163 -3.712668 +288 96 2 0 -2.937568 3.025005 -3.971189 +289 97 1 0 -8.786626 -3.149090 -1.640379 +290 97 2 0 -8.441651 -4.011755 -1.901885 +291 97 2 0 -9.285717 -3.276173 -0.834535 +292 98 1 0 -7.358188 8.239942 -2.093781 +293 98 2 0 -7.811518 7.751233 -2.768278 +294 98 2 0 -6.892430 7.625331 -1.541437 +295 99 1 0 3.770974 -0.453172 -1.931225 +296 99 2 0 4.245757 -0.966218 -1.286114 +297 99 2 0 3.797803 0.441972 -1.542180 +298 100 1 0 2.205813 4.098894 8.958738 +299 100 2 0 3.001973 3.555440 8.746430 +300 100 2 0 2.103639 4.243668 9.940011 +301 101 1 0 -8.723398 -8.284874 -8.890692 +302 101 2 0 -9.298972 -7.537539 -9.239127 +303 101 2 0 -8.772683 -8.361037 -7.925940 +304 102 1 0 -8.908952 0.807167 -7.785764 +305 102 2 0 -9.061230 -0.061912 -7.422589 +306 102 2 0 -9.534219 1.030144 -8.475490 +307 103 1 0 9.182207 -3.418263 -8.430667 +308 103 2 0 9.046738 -2.558299 -8.879898 +309 103 2 0 8.390804 -3.958734 -8.701949 +310 104 1 0 1.003162 9.279867 -8.313986 +311 104 2 0 1.167271 10.190392 -8.070619 +312 104 2 0 1.849962 8.761188 -8.493178 +313 105 1 0 -1.842572 4.893383 8.198130 +314 105 2 0 -2.468210 5.316242 8.833179 +315 105 2 0 -1.155294 4.389410 8.716281 +316 106 1 0 -4.005055 -3.953707 0.402347 +317 106 2 0 -3.682148 -3.305443 1.058769 +318 106 2 0 -4.738199 -4.452434 0.841144 +319 107 1 0 3.511815 -7.590537 -9.004707 +320 107 2 0 3.415066 -7.281286 -8.094635 +321 107 2 0 3.251550 -6.835442 -9.579171 +322 108 1 0 -7.614136 -7.773463 1.262079 +323 108 2 0 -7.489497 -6.927033 0.753779 +324 108 2 0 -8.528840 -8.050689 1.164710 +325 109 1 0 -5.419143 7.061880 -5.745275 +326 109 2 0 -4.504905 6.840455 -5.750772 +327 109 2 0 -5.895918 6.221393 -5.676189 +328 110 1 0 -9.017162 1.888781 0.937813 +329 110 2 0 -9.868157 2.115056 0.623903 +330 110 2 0 -8.466599 1.708818 0.191067 +331 111 1 0 -8.037596 -5.106016 4.750802 +332 111 2 0 -7.322228 -5.707104 5.043673 +333 111 2 0 -8.230169 -4.481051 5.475067 +334 112 1 0 -4.390546 1.691502 -7.756245 +335 112 2 0 -3.558844 1.264966 -7.996466 +336 112 2 0 -4.136121 2.629917 -7.760619 +337 113 1 0 -3.975194 -6.218233 -6.927330 +338 113 2 0 -3.085645 -6.066352 -7.325296 +339 113 2 0 -4.640815 -6.676349 -7.524295 +340 114 1 0 8.240648 5.082183 -8.857912 +341 114 2 0 7.453645 5.101728 -8.259448 +342 114 2 0 8.368223 4.228825 -9.227974 +343 115 1 0 1.598931 -1.829796 -0.316752 +344 115 2 0 1.992252 -1.475465 -1.149815 +345 115 2 0 1.726926 -2.749881 -0.397199 +346 116 1 0 1.433819 -1.386702 -3.304673 +347 116 2 0 1.323094 -0.486757 -3.067110 +348 116 2 0 0.623143 -1.802016 -3.264828 +349 117 1 0 3.735991 5.554990 6.219603 +350 117 2 0 3.320916 6.265941 6.761937 +351 117 2 0 4.195666 6.053207 5.526652 +352 118 1 0 -6.285976 -9.228132 -4.460410 +353 118 2 0 -5.683885 -10.005163 -4.740870 +354 118 2 0 -6.707036 -9.488426 -3.608438 +355 119 1 0 4.036200 -3.378299 6.905724 +356 119 2 0 3.457441 -2.618106 6.794504 +357 119 2 0 4.929409 -2.991177 6.666963 +358 120 1 0 0.606517 8.561279 -3.782406 +359 120 2 0 0.498099 9.526035 -3.699299 +360 120 2 0 1.288545 8.500162 -4.475972 +361 121 1 0 -5.666717 8.368298 -8.299623 +362 121 2 0 -4.926661 7.904359 -8.744783 +363 121 2 0 -5.742748 8.095703 -7.389592 +364 122 1 0 -3.344692 7.636718 3.475830 +365 122 2 0 -4.140634 7.105012 3.296472 +366 122 2 0 -3.350797 7.470949 4.433350 +367 123 1 0 -1.322186 6.638182 0.028906 +368 123 2 0 -1.895088 6.054034 0.554933 +369 123 2 0 -1.928852 7.271511 -0.442137 +370 124 1 0 8.793551 6.925450 7.841717 +371 124 2 0 9.639675 7.325848 7.850680 +372 124 2 0 8.776882 6.398711 8.674036 +373 125 1 0 -6.322101 0.607808 1.174099 +374 125 2 0 -5.647986 1.150825 1.588348 +375 125 2 0 -5.852992 -0.060471 0.660730 +376 126 1 0 5.685139 -3.546046 -4.128549 +377 126 2 0 4.727966 -3.473549 -4.165755 +378 126 2 0 6.024761 -2.749532 -4.610993 +379 127 1 0 3.821999 6.538527 1.678030 +380 127 2 0 3.549684 7.331168 1.175762 +381 127 2 0 3.816423 6.788603 2.602522 +382 128 1 0 3.892622 -7.034239 -6.415978 +383 128 2 0 4.720509 -6.539827 -6.295004 +384 128 2 0 3.262810 -6.550918 -5.890370 +385 129 1 0 5.454437 3.881722 -2.767521 +386 129 2 0 5.906266 3.240489 -3.272250 +387 129 2 0 6.116652 4.657253 -2.669082 +388 130 1 0 -4.179373 -8.326009 4.395005 +389 130 2 0 -3.737878 -8.754475 5.134173 +390 130 2 0 -3.934584 -8.825320 3.534465 +391 131 1 0 7.949488 -1.353498 9.244688 +392 131 2 0 7.234465 -1.100736 9.869694 +393 131 2 0 8.010855 -0.754076 8.476271 +394 132 1 0 4.498603 -4.219267 3.963173 +395 132 2 0 4.895226 -3.311215 4.147093 +396 132 2 0 4.802371 -4.871698 4.671292 +397 133 1 0 -4.307250 7.384668 -2.879462 +398 133 2 0 -3.402854 7.237543 -3.252031 +399 133 2 0 -4.143231 7.834459 -2.019767 +400 134 1 0 2.868752 -0.418389 1.909340 +401 134 2 0 2.544472 -0.880398 1.179279 +402 134 2 0 2.082841 -0.227627 2.457964 +403 135 1 0 7.961389 1.611971 4.525253 +404 135 2 0 7.498497 1.833174 3.728113 +405 135 2 0 8.841880 2.050996 4.576281 +406 136 1 0 2.692467 -4.517946 -0.884665 +407 136 2 0 1.789435 -4.835617 -0.587396 +408 136 2 0 3.330887 -5.126025 -0.474679 +409 137 1 0 0.711797 1.680547 -4.780435 +410 137 2 0 0.854596 1.567911 -3.850059 +411 137 2 0 -0.187286 1.868256 -4.936632 +412 138 1 0 4.558200 -0.044434 -4.673875 +413 138 2 0 5.376141 -0.551202 -4.913295 +414 138 2 0 4.409600 -0.197728 -3.739555 +415 139 1 0 7.109730 0.453475 -0.268844 +416 139 2 0 6.996444 0.098599 -1.119484 +417 139 2 0 6.343115 1.050849 -0.110689 +418 140 1 0 -2.549577 -0.200852 -4.492507 +419 140 2 0 -3.199039 -0.856439 -4.888752 +420 140 2 0 -2.605120 -0.151501 -3.534000 +421 141 1 0 -8.527353 4.524174 -2.347408 +422 141 2 0 -7.662213 4.342466 -2.104852 +423 141 2 0 -8.794374 3.696793 -2.795740 +424 142 1 0 -2.820431 -0.700478 4.413266 +425 142 2 0 -2.088343 -0.069797 4.530521 +426 142 2 0 -3.535913 -0.413547 5.069151 +427 143 1 0 6.924598 -1.285634 -4.901833 +428 143 2 0 7.496477 -0.831510 -4.206076 +429 143 2 0 7.527035 -1.446676 -5.677236 +430 144 1 0 -5.353763 6.572088 6.734366 +431 144 2 0 -4.428432 6.663173 6.834862 +432 144 2 0 -5.603600 6.385787 5.822425 +433 145 1 0 7.661597 2.386104 9.175259 +434 145 2 0 7.321694 2.395921 10.055536 +435 145 2 0 6.959141 2.102200 8.533079 +436 146 1 0 -3.496590 -3.765912 -4.994838 +437 146 2 0 -3.612181 -3.620689 -4.036115 +438 146 2 0 -4.323649 -3.527816 -5.463213 +439 147 1 0 -9.351953 8.343146 3.704719 +440 147 2 0 -8.465363 8.758592 3.736785 +441 147 2 0 -9.159223 7.399420 3.880808 +442 148 1 0 -0.957571 -5.174275 -2.190170 +443 148 2 0 -1.907345 -5.209294 -2.303164 +444 148 2 0 -0.758582 -4.314608 -2.636469 +445 149 1 0 5.048831 -7.988284 2.587515 +446 149 2 0 5.870168 -8.296198 3.043816 +447 149 2 0 4.551970 -7.498875 3.229280 +448 150 1 0 3.705658 8.368298 -8.304931 +449 150 2 0 3.860607 9.297256 -8.425405 +450 150 2 0 3.866516 8.146007 -7.371475 +451 151 1 0 -2.535134 7.116414 6.338590 +452 151 2 0 -1.918884 7.705593 6.804078 +453 151 2 0 -1.975225 6.330832 6.121365 +454 152 1 0 -3.440263 7.005018 9.111704 +455 152 2 0 -2.633953 7.421761 9.465848 +456 152 2 0 -3.654896 7.513753 8.256470 +457 153 1 0 6.452501 -5.478051 -5.722874 +458 153 2 0 7.297698 -5.914122 -5.586895 +459 153 2 0 6.253267 -4.919338 -4.937095 +460 154 1 0 -6.528475 4.497861 -5.573636 +461 154 2 0 -6.257840 4.684056 -4.656222 +462 154 2 0 -7.247764 3.931701 -5.623068 +463 155 1 0 -7.310706 8.183648 7.852201 +464 155 2 0 -6.552879 7.735013 7.436342 +465 155 2 0 -6.877865 8.451022 8.686616 +466 156 1 0 -1.476441 -7.867001 7.421787 +467 156 2 0 -0.852398 -8.570669 7.084405 +468 156 2 0 -1.363740 -7.190554 6.737331 +469 157 1 0 5.228019 -0.495870 -7.592953 +470 157 2 0 4.737616 -0.538139 -6.742036 +471 157 2 0 4.625354 -0.901329 -8.269022 +472 158 1 0 7.566531 -1.006734 1.808213 +473 158 2 0 7.657411 -1.866188 1.428564 +474 158 2 0 7.358547 -0.388051 1.139943 +475 159 1 0 1.850924 -5.717449 -5.035416 +476 159 2 0 1.721040 -6.227449 -4.217213 +477 159 2 0 2.199319 -4.856378 -4.692892 +478 160 1 0 -8.904325 6.791585 -3.842866 +479 160 2 0 -8.690637 5.952112 -3.490118 +480 160 2 0 -8.676001 6.844077 -4.770651 +481 161 1 0 -3.434304 4.397198 -7.863568 +482 161 2 0 -2.634777 3.892027 -7.779256 +483 161 2 0 -3.432847 5.161485 -7.310788 +484 162 1 0 -7.446738 6.124823 0.150068 +485 162 2 0 -7.404893 5.207959 0.481504 +486 162 2 0 -8.405563 6.215466 -0.024439 +487 163 1 0 0.195330 -7.307128 -3.501714 +488 163 2 0 -0.240912 -6.769004 -4.243655 +489 163 2 0 -0.194915 -6.981989 -2.679860 +490 164 1 0 7.068819 9.130323 7.260588 +491 164 2 0 6.559855 8.400987 7.699406 +492 164 2 0 7.972497 8.829223 7.213747 +493 165 1 0 -0.185218 -3.192290 -6.289346 +494 165 2 0 0.776651 -3.073203 -6.391948 +495 165 2 0 -0.497426 -2.964088 -7.170893 +496 166 1 0 -2.073630 4.369672 5.251074 +497 166 2 0 -1.868638 3.811508 6.060261 +498 166 2 0 -1.253174 4.326708 4.781680 +499 167 1 0 -0.855003 3.069108 -7.935226 +500 167 2 0 0.075758 3.132202 -7.617253 +501 167 2 0 -1.009845 2.207487 -8.320426 +502 168 1 0 -6.328833 0.064083 -8.467228 +503 168 2 0 -7.268416 0.384648 -8.383978 +504 168 2 0 -5.825246 0.919304 -8.320175 +505 169 1 0 -8.276352 -8.809851 -6.344910 +506 169 2 0 -7.541457 -8.792368 -5.688031 +507 169 2 0 -8.510208 -9.731116 -6.353248 +508 170 1 0 0.463654 2.826776 7.018388 +509 170 2 0 0.875324 3.588447 7.482107 +510 170 2 0 0.770257 2.126646 7.583650 +511 171 1 0 0.478371 -3.407198 6.910039 +512 171 2 0 0.585298 -2.996750 7.756467 +513 171 2 0 0.556531 -4.390636 7.183527 +514 172 1 0 -1.689559 7.002511 -3.303561 +515 172 2 0 -1.009152 7.635432 -3.553133 +516 172 2 0 -1.333699 6.195680 -2.919485 +517 173 1 0 9.000097 -6.227871 8.137681 +518 173 2 0 9.373858 -6.821152 7.497417 +519 173 2 0 8.024020 -6.011019 8.033727 +520 174 1 0 1.272378 1.954065 3.058033 +521 174 2 0 1.260842 2.615112 2.341207 +522 174 2 0 1.890312 2.223439 3.732934 +523 175 1 0 4.139066 -3.527427 -9.022609 +524 175 2 0 4.070028 -3.499117 -9.985525 +525 175 2 0 4.960292 -3.942364 -8.778433 +526 176 1 0 7.176276 2.178662 -4.075940 +527 176 2 0 6.995275 1.684022 -4.873223 +528 176 2 0 7.621313 2.984315 -4.393994 +529 177 1 0 -0.034836 -3.929919 2.148095 +530 177 2 0 0.838003 -3.513346 2.259663 +531 177 2 0 -0.654999 -3.288581 2.426748 +532 178 1 0 -8.701616 2.795237 -5.700842 +533 178 2 0 -8.848959 2.145603 -6.420186 +534 178 2 0 -9.464654 3.362988 -5.610379 +535 179 1 0 2.804444 8.909551 -5.635389 +536 179 2 0 3.063615 9.805993 -5.770957 +537 179 2 0 3.512196 8.486179 -5.165468 +538 180 1 0 3.236002 8.357402 3.636639 +539 180 2 0 3.450854 9.071799 3.073263 +540 180 2 0 3.476445 8.586691 4.607935 +541 181 1 0 5.628532 7.185941 8.510937 +542 181 2 0 5.467837 6.318153 8.138885 +543 181 2 0 4.964153 7.477925 9.150467 +544 182 1 0 -3.767261 1.260390 2.017681 +545 182 2 0 -3.707734 2.019520 2.565591 +546 182 2 0 -3.364602 1.609935 1.212351 +547 183 1 0 8.228917 -3.441761 0.850139 +548 183 2 0 9.022130 -3.709208 1.334881 +549 183 2 0 7.553662 -3.976731 1.276651 +550 184 1 0 -3.004292 1.345869 7.236734 +551 184 2 0 -3.715311 0.724731 6.912689 +552 184 2 0 -3.525684 2.111901 7.538936 +553 185 1 0 4.901423 -5.547141 -0.119795 +554 185 2 0 5.327550 -5.560969 0.769770 +555 185 2 0 5.447642 -4.930752 -0.617088 +556 186 1 0 -3.306210 8.469477 -0.495057 +557 186 2 0 -2.836855 9.122642 -1.080706 +558 186 2 0 -3.311215 8.916887 0.353875 +559 187 1 0 -6.572180 3.018421 -0.262079 +560 187 2 0 -6.711444 2.659956 0.606460 +561 187 2 0 -6.040782 2.473886 -0.843542 +562 188 1 0 -5.429147 -5.967833 5.177682 +563 188 2 0 -4.896648 -6.608203 4.692534 +564 188 2 0 -5.386594 -6.130690 6.117931 +565 189 1 0 6.054430 7.035601 0.031519 +566 189 2 0 5.939348 7.951184 -0.141094 +567 189 2 0 5.390949 6.866654 0.702638 +568 190 1 0 -0.890229 -2.615376 -3.621726 +569 190 2 0 -1.695442 -2.097314 -3.537976 +570 190 2 0 -0.895128 -2.637531 -4.561712 +571 191 1 0 -5.446979 0.994907 -2.106714 +572 191 2 0 -4.494883 0.997912 -1.881595 +573 191 2 0 -5.759736 0.094199 -1.919247 +574 192 1 0 -7.517688 -4.078340 7.202707 +575 192 2 0 -8.242348 -4.324693 7.729813 +576 192 2 0 -6.924399 -4.817453 7.269430 +577 193 1 0 -1.134884 8.628488 2.081069 +578 193 2 0 -1.962897 8.634713 2.554947 +579 193 2 0 -1.119731 7.882422 1.516003 +580 194 1 0 -6.288317 8.011683 2.022129 +581 194 2 0 -6.404647 8.858198 1.546109 +582 194 2 0 -6.669138 7.315199 1.482614 +583 195 1 0 -6.766934 -4.026505 -8.306645 +584 195 2 0 -6.542552 -4.855702 -8.828363 +585 195 2 0 -7.743726 -3.954163 -8.170031 +586 196 1 0 6.895244 7.052113 -3.031289 +587 196 2 0 7.810039 7.265357 -3.330751 +588 196 2 0 6.666757 7.541675 -2.202178 +589 197 1 0 8.003260 4.735929 -5.168656 +590 197 2 0 7.233375 4.730204 -5.685772 +591 197 2 0 8.406708 5.629580 -5.300038 +592 198 1 0 -5.230160 -6.461196 -4.390836 +593 198 2 0 -5.701559 -7.313756 -4.377348 +594 198 2 0 -4.855545 -6.327970 -5.273444 +595 199 1 0 -3.803496 -9.221115 7.305476 +596 199 2 0 -2.934288 -8.877999 7.425047 +597 199 2 0 -4.416066 -8.566250 7.573191 +598 200 1 0 -5.990438 -1.574415 3.072521 +599 200 2 0 -5.805447 -1.119293 3.933731 +600 200 2 0 -6.651651 -0.947206 2.634773 +601 201 1 0 1.155451 7.138377 -1.178317 +602 201 2 0 0.330359 7.363227 -0.724568 +603 201 2 0 1.055145 7.478676 -2.100793 +604 202 1 0 -5.886817 5.150957 -2.997276 +605 202 2 0 -5.191777 4.556623 -2.611465 +606 202 2 0 -5.401622 6.003350 -3.064194 +607 203 1 0 2.539927 3.387568 4.976180 +608 203 2 0 1.760904 3.182324 5.589217 +609 203 2 0 2.841539 4.315465 5.278853 +610 204 1 0 8.331859 -7.344673 -5.188191 +611 204 2 0 8.424401 -7.586778 -4.198621 +612 204 2 0 8.911675 -7.764424 -5.823267 +613 205 1 0 -5.774081 1.315144 -5.304553 +614 205 2 0 -5.222992 1.580336 -6.077077 +615 205 2 0 -6.219878 2.178441 -5.093360 +616 206 1 0 6.340084 -4.926064 2.149626 +617 206 2 0 5.639784 -4.766017 2.829591 +618 206 2 0 6.883511 -5.598794 2.562820 +619 207 1 0 -2.722394 6.614441 -5.843805 +620 207 2 0 -2.332414 7.251953 -6.403722 +621 207 2 0 -2.221682 6.596615 -5.034993 +622 208 1 0 -1.813152 0.712824 -9.048176 +623 208 2 0 -1.763921 -0.271744 -8.916841 +624 208 2 0 -2.097796 0.860500 -9.970314 +625 209 1 0 6.146244 -6.879929 8.376712 +626 209 2 0 5.324465 -7.183905 8.841506 +627 209 2 0 6.642264 -7.749945 8.201756 +628 210 1 0 2.887544 8.612615 0.453821 +629 210 2 0 2.452117 8.047637 -0.251289 +630 210 2 0 2.348751 9.285636 0.895642 +631 211 1 0 -8.475558 -8.180718 6.501232 +632 211 2 0 -8.034310 -8.945692 6.891221 +633 211 2 0 -8.173606 -8.179435 5.569319 +634 212 1 0 6.714205 -2.947903 6.551671 +635 212 2 0 7.143284 -2.459194 7.270891 +636 212 2 0 7.212365 -2.637046 5.791018 +637 213 1 0 6.445003 -5.462306 5.577966 +638 213 2 0 6.730099 -4.696457 6.073312 +639 213 2 0 6.099428 -6.099736 6.222859 +640 214 1 0 -1.818761 -6.080111 -8.805420 +641 214 2 0 -1.644534 -6.777931 -9.477669 +642 214 2 0 -2.078582 -5.258591 -9.215838 +643 215 1 0 6.037377 2.950576 2.863541 +644 215 2 0 6.409766 3.757001 2.570754 +645 215 2 0 5.577033 2.617474 2.090587 +646 216 1 0 -7.731645 3.337668 3.301121 +647 216 2 0 -8.345957 4.027222 3.589257 +648 216 2 0 -8.130328 2.845238 2.577949 + +Bonds + +1 1 1 2 +2 1 1 3 +3 1 4 5 +4 1 4 6 +5 1 7 8 +6 1 7 9 +7 1 10 11 +8 1 10 12 +9 1 13 14 +10 1 13 15 +11 1 16 17 +12 1 16 18 +13 1 19 20 +14 1 19 21 +15 1 22 23 +16 1 22 24 +17 1 25 26 +18 1 25 27 +19 1 28 29 +20 1 28 30 +21 1 31 32 +22 1 31 33 +23 1 34 35 +24 1 34 36 +25 1 37 38 +26 1 37 39 +27 1 40 41 +28 1 40 42 +29 1 43 44 +30 1 43 45 +31 1 46 47 +32 1 46 48 +33 1 49 50 +34 1 49 51 +35 1 52 53 +36 1 52 54 +37 1 55 56 +38 1 55 57 +39 1 58 59 +40 1 58 60 +41 1 61 62 +42 1 61 63 +43 1 64 65 +44 1 64 66 +45 1 67 68 +46 1 67 69 +47 1 70 71 +48 1 70 72 +49 1 73 74 +50 1 73 75 +51 1 76 77 +52 1 76 78 +53 1 79 80 +54 1 79 81 +55 1 82 83 +56 1 82 84 +57 1 85 86 +58 1 85 87 +59 1 88 89 +60 1 88 90 +61 1 91 92 +62 1 91 93 +63 1 94 95 +64 1 94 96 +65 1 97 98 +66 1 97 99 +67 1 100 101 +68 1 100 102 +69 1 103 104 +70 1 103 105 +71 1 106 107 +72 1 106 108 +73 1 109 110 +74 1 109 111 +75 1 112 113 +76 1 112 114 +77 1 115 116 +78 1 115 117 +79 1 118 119 +80 1 118 120 +81 1 121 122 +82 1 121 123 +83 1 124 125 +84 1 124 126 +85 1 127 128 +86 1 127 129 +87 1 130 131 +88 1 130 132 +89 1 133 134 +90 1 133 135 +91 1 136 137 +92 1 136 138 +93 1 139 140 +94 1 139 141 +95 1 142 143 +96 1 142 144 +97 1 145 146 +98 1 145 147 +99 1 148 149 +100 1 148 150 +101 1 151 152 +102 1 151 153 +103 1 154 155 +104 1 154 156 +105 1 157 158 +106 1 157 159 +107 1 160 161 +108 1 160 162 +109 1 163 164 +110 1 163 165 +111 1 166 167 +112 1 166 168 +113 1 169 170 +114 1 169 171 +115 1 172 173 +116 1 172 174 +117 1 175 176 +118 1 175 177 +119 1 178 179 +120 1 178 180 +121 1 181 182 +122 1 181 183 +123 1 184 185 +124 1 184 186 +125 1 187 188 +126 1 187 189 +127 1 190 191 +128 1 190 192 +129 1 193 194 +130 1 193 195 +131 1 196 197 +132 1 196 198 +133 1 199 200 +134 1 199 201 +135 1 202 203 +136 1 202 204 +137 1 205 206 +138 1 205 207 +139 1 208 209 +140 1 208 210 +141 1 211 212 +142 1 211 213 +143 1 214 215 +144 1 214 216 +145 1 217 218 +146 1 217 219 +147 1 220 221 +148 1 220 222 +149 1 223 224 +150 1 223 225 +151 1 226 227 +152 1 226 228 +153 1 229 230 +154 1 229 231 +155 1 232 233 +156 1 232 234 +157 1 235 236 +158 1 235 237 +159 1 238 239 +160 1 238 240 +161 1 241 242 +162 1 241 243 +163 1 244 245 +164 1 244 246 +165 1 247 248 +166 1 247 249 +167 1 250 251 +168 1 250 252 +169 1 253 254 +170 1 253 255 +171 1 256 257 +172 1 256 258 +173 1 259 260 +174 1 259 261 +175 1 262 263 +176 1 262 264 +177 1 265 266 +178 1 265 267 +179 1 268 269 +180 1 268 270 +181 1 271 272 +182 1 271 273 +183 1 274 275 +184 1 274 276 +185 1 277 278 +186 1 277 279 +187 1 280 281 +188 1 280 282 +189 1 283 284 +190 1 283 285 +191 1 286 287 +192 1 286 288 +193 1 289 290 +194 1 289 291 +195 1 292 293 +196 1 292 294 +197 1 295 296 +198 1 295 297 +199 1 298 299 +200 1 298 300 +201 1 301 302 +202 1 301 303 +203 1 304 305 +204 1 304 306 +205 1 307 308 +206 1 307 309 +207 1 310 311 +208 1 310 312 +209 1 313 314 +210 1 313 315 +211 1 316 317 +212 1 316 318 +213 1 319 320 +214 1 319 321 +215 1 322 323 +216 1 322 324 +217 1 325 326 +218 1 325 327 +219 1 328 329 +220 1 328 330 +221 1 331 332 +222 1 331 333 +223 1 334 335 +224 1 334 336 +225 1 337 338 +226 1 337 339 +227 1 340 341 +228 1 340 342 +229 1 343 344 +230 1 343 345 +231 1 346 347 +232 1 346 348 +233 1 349 350 +234 1 349 351 +235 1 352 353 +236 1 352 354 +237 1 355 356 +238 1 355 357 +239 1 358 359 +240 1 358 360 +241 1 361 362 +242 1 361 363 +243 1 364 365 +244 1 364 366 +245 1 367 368 +246 1 367 369 +247 1 370 371 +248 1 370 372 +249 1 373 374 +250 1 373 375 +251 1 376 377 +252 1 376 378 +253 1 379 380 +254 1 379 381 +255 1 382 383 +256 1 382 384 +257 1 385 386 +258 1 385 387 +259 1 388 389 +260 1 388 390 +261 1 391 392 +262 1 391 393 +263 1 394 395 +264 1 394 396 +265 1 397 398 +266 1 397 399 +267 1 400 401 +268 1 400 402 +269 1 403 404 +270 1 403 405 +271 1 406 407 +272 1 406 408 +273 1 409 410 +274 1 409 411 +275 1 412 413 +276 1 412 414 +277 1 415 416 +278 1 415 417 +279 1 418 419 +280 1 418 420 +281 1 421 422 +282 1 421 423 +283 1 424 425 +284 1 424 426 +285 1 427 428 +286 1 427 429 +287 1 430 431 +288 1 430 432 +289 1 433 434 +290 1 433 435 +291 1 436 437 +292 1 436 438 +293 1 439 440 +294 1 439 441 +295 1 442 443 +296 1 442 444 +297 1 445 446 +298 1 445 447 +299 1 448 449 +300 1 448 450 +301 1 451 452 +302 1 451 453 +303 1 454 455 +304 1 454 456 +305 1 457 458 +306 1 457 459 +307 1 460 461 +308 1 460 462 +309 1 463 464 +310 1 463 465 +311 1 466 467 +312 1 466 468 +313 1 469 470 +314 1 469 471 +315 1 472 473 +316 1 472 474 +317 1 475 476 +318 1 475 477 +319 1 478 479 +320 1 478 480 +321 1 481 482 +322 1 481 483 +323 1 484 485 +324 1 484 486 +325 1 487 488 +326 1 487 489 +327 1 490 491 +328 1 490 492 +329 1 493 494 +330 1 493 495 +331 1 496 497 +332 1 496 498 +333 1 499 500 +334 1 499 501 +335 1 502 503 +336 1 502 504 +337 1 505 506 +338 1 505 507 +339 1 508 509 +340 1 508 510 +341 1 511 512 +342 1 511 513 +343 1 514 515 +344 1 514 516 +345 1 517 518 +346 1 517 519 +347 1 520 521 +348 1 520 522 +349 1 523 524 +350 1 523 525 +351 1 526 527 +352 1 526 528 +353 1 529 530 +354 1 529 531 +355 1 532 533 +356 1 532 534 +357 1 535 536 +358 1 535 537 +359 1 538 539 +360 1 538 540 +361 1 541 542 +362 1 541 543 +363 1 544 545 +364 1 544 546 +365 1 547 548 +366 1 547 549 +367 1 550 551 +368 1 550 552 +369 1 553 554 +370 1 553 555 +371 1 556 557 +372 1 556 558 +373 1 559 560 +374 1 559 561 +375 1 562 563 +376 1 562 564 +377 1 565 566 +378 1 565 567 +379 1 568 569 +380 1 568 570 +381 1 571 572 +382 1 571 573 +383 1 574 575 +384 1 574 576 +385 1 577 578 +386 1 577 579 +387 1 580 581 +388 1 580 582 +389 1 583 584 +390 1 583 585 +391 1 586 587 +392 1 586 588 +393 1 589 590 +394 1 589 591 +395 1 592 593 +396 1 592 594 +397 1 595 596 +398 1 595 597 +399 1 598 599 +400 1 598 600 +401 1 601 602 +402 1 601 603 +403 1 604 605 +404 1 604 606 +405 1 607 608 +406 1 607 609 +407 1 610 611 +408 1 610 612 +409 1 613 614 +410 1 613 615 +411 1 616 617 +412 1 616 618 +413 1 619 620 +414 1 619 621 +415 1 622 623 +416 1 622 624 +417 1 625 626 +418 1 625 627 +419 1 628 629 +420 1 628 630 +421 1 631 632 +422 1 631 633 +423 1 634 635 +424 1 634 636 +425 1 637 638 +426 1 637 639 +427 1 640 641 +428 1 640 642 +429 1 643 644 +430 1 643 645 +431 1 646 647 +432 1 646 648 + +Angles + +1 1 2 1 3 +2 1 5 4 6 +3 1 8 7 9 +4 1 11 10 12 +5 1 14 13 15 +6 1 17 16 18 +7 1 20 19 21 +8 1 23 22 24 +9 1 26 25 27 +10 1 29 28 30 +11 1 32 31 33 +12 1 35 34 36 +13 1 38 37 39 +14 1 41 40 42 +15 1 44 43 45 +16 1 47 46 48 +17 1 50 49 51 +18 1 53 52 54 +19 1 56 55 57 +20 1 59 58 60 +21 1 62 61 63 +22 1 65 64 66 +23 1 68 67 69 +24 1 71 70 72 +25 1 74 73 75 +26 1 77 76 78 +27 1 80 79 81 +28 1 83 82 84 +29 1 86 85 87 +30 1 89 88 90 +31 1 92 91 93 +32 1 95 94 96 +33 1 98 97 99 +34 1 101 100 102 +35 1 104 103 105 +36 1 107 106 108 +37 1 110 109 111 +38 1 113 112 114 +39 1 116 115 117 +40 1 119 118 120 +41 1 122 121 123 +42 1 125 124 126 +43 1 128 127 129 +44 1 131 130 132 +45 1 134 133 135 +46 1 137 136 138 +47 1 140 139 141 +48 1 143 142 144 +49 1 146 145 147 +50 1 149 148 150 +51 1 152 151 153 +52 1 155 154 156 +53 1 158 157 159 +54 1 161 160 162 +55 1 164 163 165 +56 1 167 166 168 +57 1 170 169 171 +58 1 173 172 174 +59 1 176 175 177 +60 1 179 178 180 +61 1 182 181 183 +62 1 185 184 186 +63 1 188 187 189 +64 1 191 190 192 +65 1 194 193 195 +66 1 197 196 198 +67 1 200 199 201 +68 1 203 202 204 +69 1 206 205 207 +70 1 209 208 210 +71 1 212 211 213 +72 1 215 214 216 +73 1 218 217 219 +74 1 221 220 222 +75 1 224 223 225 +76 1 227 226 228 +77 1 230 229 231 +78 1 233 232 234 +79 1 236 235 237 +80 1 239 238 240 +81 1 242 241 243 +82 1 245 244 246 +83 1 248 247 249 +84 1 251 250 252 +85 1 254 253 255 +86 1 257 256 258 +87 1 260 259 261 +88 1 263 262 264 +89 1 266 265 267 +90 1 269 268 270 +91 1 272 271 273 +92 1 275 274 276 +93 1 278 277 279 +94 1 281 280 282 +95 1 284 283 285 +96 1 287 286 288 +97 1 290 289 291 +98 1 293 292 294 +99 1 296 295 297 +100 1 299 298 300 +101 1 302 301 303 +102 1 305 304 306 +103 1 308 307 309 +104 1 311 310 312 +105 1 314 313 315 +106 1 317 316 318 +107 1 320 319 321 +108 1 323 322 324 +109 1 326 325 327 +110 1 329 328 330 +111 1 332 331 333 +112 1 335 334 336 +113 1 338 337 339 +114 1 341 340 342 +115 1 344 343 345 +116 1 347 346 348 +117 1 350 349 351 +118 1 353 352 354 +119 1 356 355 357 +120 1 359 358 360 +121 1 362 361 363 +122 1 365 364 366 +123 1 368 367 369 +124 1 371 370 372 +125 1 374 373 375 +126 1 377 376 378 +127 1 380 379 381 +128 1 383 382 384 +129 1 386 385 387 +130 1 389 388 390 +131 1 392 391 393 +132 1 395 394 396 +133 1 398 397 399 +134 1 401 400 402 +135 1 404 403 405 +136 1 407 406 408 +137 1 410 409 411 +138 1 413 412 414 +139 1 416 415 417 +140 1 419 418 420 +141 1 422 421 423 +142 1 425 424 426 +143 1 428 427 429 +144 1 431 430 432 +145 1 434 433 435 +146 1 437 436 438 +147 1 440 439 441 +148 1 443 442 444 +149 1 446 445 447 +150 1 449 448 450 +151 1 452 451 453 +152 1 455 454 456 +153 1 458 457 459 +154 1 461 460 462 +155 1 464 463 465 +156 1 467 466 468 +157 1 470 469 471 +158 1 473 472 474 +159 1 476 475 477 +160 1 479 478 480 +161 1 482 481 483 +162 1 485 484 486 +163 1 488 487 489 +164 1 491 490 492 +165 1 494 493 495 +166 1 497 496 498 +167 1 500 499 501 +168 1 503 502 504 +169 1 506 505 507 +170 1 509 508 510 +171 1 512 511 513 +172 1 515 514 516 +173 1 518 517 519 +174 1 521 520 522 +175 1 524 523 525 +176 1 527 526 528 +177 1 530 529 531 +178 1 533 532 534 +179 1 536 535 537 +180 1 539 538 540 +181 1 542 541 543 +182 1 545 544 546 +183 1 548 547 549 +184 1 551 550 552 +185 1 554 553 555 +186 1 557 556 558 +187 1 560 559 561 +188 1 563 562 564 +189 1 566 565 567 +190 1 569 568 570 +191 1 572 571 573 +192 1 575 574 576 +193 1 578 577 579 +194 1 581 580 582 +195 1 584 583 585 +196 1 587 586 588 +197 1 590 589 591 +198 1 593 592 594 +199 1 596 595 597 +200 1 599 598 600 +201 1 602 601 603 +202 1 605 604 606 +203 1 608 607 609 +204 1 611 610 612 +205 1 614 613 615 +206 1 617 616 618 +207 1 620 619 621 +208 1 623 622 624 +209 1 626 625 627 +210 1 629 628 630 +211 1 632 631 633 +212 1 635 634 636 +213 1 638 637 639 +214 1 641 640 642 +215 1 644 643 645 +216 1 647 646 648 + +Bond Coeffs + +1 0.9572 556.85 -1419.9675 2112.20165625 + +Angle Coeffs + +1 0 108.5 48.7 -39.064262472 8.95286947775 -6.41202044508 11.5462823034 + +Tinker Types + +1 1 +2 2 +3 2 +4 1 +5 2 +6 2 +7 1 +8 2 +9 2 +10 1 +11 2 +12 2 +13 1 +14 2 +15 2 +16 1 +17 2 +18 2 +19 1 +20 2 +21 2 +22 1 +23 2 +24 2 +25 1 +26 2 +27 2 +28 1 +29 2 +30 2 +31 1 +32 2 +33 2 +34 1 +35 2 +36 2 +37 1 +38 2 +39 2 +40 1 +41 2 +42 2 +43 1 +44 2 +45 2 +46 1 +47 2 +48 2 +49 1 +50 2 +51 2 +52 1 +53 2 +54 2 +55 1 +56 2 +57 2 +58 1 +59 2 +60 2 +61 1 +62 2 +63 2 +64 1 +65 2 +66 2 +67 1 +68 2 +69 2 +70 1 +71 2 +72 2 +73 1 +74 2 +75 2 +76 1 +77 2 +78 2 +79 1 +80 2 +81 2 +82 1 +83 2 +84 2 +85 1 +86 2 +87 2 +88 1 +89 2 +90 2 +91 1 +92 2 +93 2 +94 1 +95 2 +96 2 +97 1 +98 2 +99 2 +100 1 +101 2 +102 2 +103 1 +104 2 +105 2 +106 1 +107 2 +108 2 +109 1 +110 2 +111 2 +112 1 +113 2 +114 2 +115 1 +116 2 +117 2 +118 1 +119 2 +120 2 +121 1 +122 2 +123 2 +124 1 +125 2 +126 2 +127 1 +128 2 +129 2 +130 1 +131 2 +132 2 +133 1 +134 2 +135 2 +136 1 +137 2 +138 2 +139 1 +140 2 +141 2 +142 1 +143 2 +144 2 +145 1 +146 2 +147 2 +148 1 +149 2 +150 2 +151 1 +152 2 +153 2 +154 1 +155 2 +156 2 +157 1 +158 2 +159 2 +160 1 +161 2 +162 2 +163 1 +164 2 +165 2 +166 1 +167 2 +168 2 +169 1 +170 2 +171 2 +172 1 +173 2 +174 2 +175 1 +176 2 +177 2 +178 1 +179 2 +180 2 +181 1 +182 2 +183 2 +184 1 +185 2 +186 2 +187 1 +188 2 +189 2 +190 1 +191 2 +192 2 +193 1 +194 2 +195 2 +196 1 +197 2 +198 2 +199 1 +200 2 +201 2 +202 1 +203 2 +204 2 +205 1 +206 2 +207 2 +208 1 +209 2 +210 2 +211 1 +212 2 +213 2 +214 1 +215 2 +216 2 +217 1 +218 2 +219 2 +220 1 +221 2 +222 2 +223 1 +224 2 +225 2 +226 1 +227 2 +228 2 +229 1 +230 2 +231 2 +232 1 +233 2 +234 2 +235 1 +236 2 +237 2 +238 1 +239 2 +240 2 +241 1 +242 2 +243 2 +244 1 +245 2 +246 2 +247 1 +248 2 +249 2 +250 1 +251 2 +252 2 +253 1 +254 2 +255 2 +256 1 +257 2 +258 2 +259 1 +260 2 +261 2 +262 1 +263 2 +264 2 +265 1 +266 2 +267 2 +268 1 +269 2 +270 2 +271 1 +272 2 +273 2 +274 1 +275 2 +276 2 +277 1 +278 2 +279 2 +280 1 +281 2 +282 2 +283 1 +284 2 +285 2 +286 1 +287 2 +288 2 +289 1 +290 2 +291 2 +292 1 +293 2 +294 2 +295 1 +296 2 +297 2 +298 1 +299 2 +300 2 +301 1 +302 2 +303 2 +304 1 +305 2 +306 2 +307 1 +308 2 +309 2 +310 1 +311 2 +312 2 +313 1 +314 2 +315 2 +316 1 +317 2 +318 2 +319 1 +320 2 +321 2 +322 1 +323 2 +324 2 +325 1 +326 2 +327 2 +328 1 +329 2 +330 2 +331 1 +332 2 +333 2 +334 1 +335 2 +336 2 +337 1 +338 2 +339 2 +340 1 +341 2 +342 2 +343 1 +344 2 +345 2 +346 1 +347 2 +348 2 +349 1 +350 2 +351 2 +352 1 +353 2 +354 2 +355 1 +356 2 +357 2 +358 1 +359 2 +360 2 +361 1 +362 2 +363 2 +364 1 +365 2 +366 2 +367 1 +368 2 +369 2 +370 1 +371 2 +372 2 +373 1 +374 2 +375 2 +376 1 +377 2 +378 2 +379 1 +380 2 +381 2 +382 1 +383 2 +384 2 +385 1 +386 2 +387 2 +388 1 +389 2 +390 2 +391 1 +392 2 +393 2 +394 1 +395 2 +396 2 +397 1 +398 2 +399 2 +400 1 +401 2 +402 2 +403 1 +404 2 +405 2 +406 1 +407 2 +408 2 +409 1 +410 2 +411 2 +412 1 +413 2 +414 2 +415 1 +416 2 +417 2 +418 1 +419 2 +420 2 +421 1 +422 2 +423 2 +424 1 +425 2 +426 2 +427 1 +428 2 +429 2 +430 1 +431 2 +432 2 +433 1 +434 2 +435 2 +436 1 +437 2 +438 2 +439 1 +440 2 +441 2 +442 1 +443 2 +444 2 +445 1 +446 2 +447 2 +448 1 +449 2 +450 2 +451 1 +452 2 +453 2 +454 1 +455 2 +456 2 +457 1 +458 2 +459 2 +460 1 +461 2 +462 2 +463 1 +464 2 +465 2 +466 1 +467 2 +468 2 +469 1 +470 2 +471 2 +472 1 +473 2 +474 2 +475 1 +476 2 +477 2 +478 1 +479 2 +480 2 +481 1 +482 2 +483 2 +484 1 +485 2 +486 2 +487 1 +488 2 +489 2 +490 1 +491 2 +492 2 +493 1 +494 2 +495 2 +496 1 +497 2 +498 2 +499 1 +500 2 +501 2 +502 1 +503 2 +504 2 +505 1 +506 2 +507 2 +508 1 +509 2 +510 2 +511 1 +512 2 +513 2 +514 1 +515 2 +516 2 +517 1 +518 2 +519 2 +520 1 +521 2 +522 2 +523 1 +524 2 +525 2 +526 1 +527 2 +528 2 +529 1 +530 2 +531 2 +532 1 +533 2 +534 2 +535 1 +536 2 +537 2 +538 1 +539 2 +540 2 +541 1 +542 2 +543 2 +544 1 +545 2 +546 2 +547 1 +548 2 +549 2 +550 1 +551 2 +552 2 +553 1 +554 2 +555 2 +556 1 +557 2 +558 2 +559 1 +560 2 +561 2 +562 1 +563 2 +564 2 +565 1 +566 2 +567 2 +568 1 +569 2 +570 2 +571 1 +572 2 +573 2 +574 1 +575 2 +576 2 +577 1 +578 2 +579 2 +580 1 +581 2 +582 2 +583 1 +584 2 +585 2 +586 1 +587 2 +588 2 +589 1 +590 2 +591 2 +592 1 +593 2 +594 2 +595 1 +596 2 +597 2 +598 1 +599 2 +600 2 +601 1 +602 2 +603 2 +604 1 +605 2 +606 2 +607 1 +608 2 +609 2 +610 1 +611 2 +612 2 +613 1 +614 2 +615 2 +616 1 +617 2 +618 2 +619 1 +620 2 +621 2 +622 1 +623 2 +624 2 +625 1 +626 2 +627 2 +628 1 +629 2 +630 2 +631 1 +632 2 +633 2 +634 1 +635 2 +636 2 +637 1 +638 2 +639 2 +640 1 +641 2 +642 2 +643 1 +644 2 +645 2 +646 1 +647 2 +648 2 diff --git a/examples/amoeba/data.water_box.hippo b/examples/amoeba/data.water_box.hippo new file mode 100644 index 0000000000..61b0dcbede --- /dev/null +++ b/examples/amoeba/data.water_box.hippo @@ -0,0 +1,1980 @@ +LAMMPS data file created from Tinker watersmall.xyz and hippo.prm files + +648 atoms +432 bonds +216 angles +2 atom types +1 bond types +1 angle types +-9.869157 9.999917 xlo xhi +-10.006163 10.191392 ylo yhi +-9.986525 10.056536 zlo zhi + +Masses + +1 15.999 +2 1.008 + +Atoms + +1 1 1 0 8.679662 7.087692 -0.696862 +2 1 2 0 7.809455 6.755792 -0.382259 +3 1 2 0 8.722232 6.814243 -1.617561 +4 2 1 0 -0.117313 8.244447 6.837616 +5 2 2 0 0.216892 7.895445 6.050027 +6 2 2 0 0.444268 7.826013 7.530196 +7 3 1 0 8.379057 -0.092611 6.814631 +8 3 2 0 9.340423 0.098069 6.734062 +9 3 2 0 7.939619 0.573676 6.269838 +10 4 1 0 6.589952 1.844323 -6.923167 +11 4 2 0 5.885429 2.402305 -6.717934 +12 4 2 0 6.181533 1.062747 -7.273678 +13 5 1 0 7.146600 5.753582 2.331517 +14 5 2 0 6.368123 6.126035 2.862678 +15 5 2 0 7.025018 6.294645 1.518196 +16 6 1 0 -2.426581 -8.504195 -2.504834 +17 6 2 0 -1.692063 -8.368252 -3.058292 +18 6 2 0 -2.793207 -7.602469 -2.403097 +19 7 1 0 -8.038375 -3.605589 2.303691 +20 7 2 0 -8.113753 -4.248127 3.018494 +21 7 2 0 -7.619392 -2.863004 2.709622 +22 8 1 0 -1.480631 8.244085 -8.272215 +23 8 2 0 -2.090204 8.687978 -7.676996 +24 8 2 0 -0.700878 8.823325 -8.322213 +25 9 1 0 -3.741962 -2.777830 -2.326319 +26 9 2 0 -4.620456 -2.444778 -2.390519 +27 9 2 0 -3.728921 -3.160952 -1.433101 +28 10 1 0 -6.467812 -5.265942 0.408263 +29 10 2 0 -6.585076 -4.796537 -0.413008 +30 10 2 0 -7.021252 -4.752640 1.007958 +31 11 1 0 9.273577 5.342431 4.055460 +32 11 2 0 8.645939 5.466500 4.837640 +33 11 2 0 8.741774 5.686149 3.302820 +34 12 1 0 1.830160 4.276731 -6.993499 +35 12 2 0 1.703275 5.223773 -6.703852 +36 12 2 0 2.408113 3.853447 -6.383339 +37 13 1 0 1.964382 6.832988 8.373101 +38 13 2 0 2.496135 7.215781 9.056298 +39 13 2 0 1.811283 5.905846 8.573539 +40 14 1 0 5.405568 4.388994 7.932737 +41 14 2 0 5.537380 3.438955 7.781311 +42 14 2 0 4.755156 4.734908 7.290617 +43 15 1 0 3.229998 2.928417 -1.090650 +44 15 2 0 3.931090 3.198265 -1.702769 +45 15 2 0 3.004438 3.708969 -0.493266 +46 16 1 0 7.462400 5.262829 6.131170 +47 16 2 0 8.025650 5.588493 6.881770 +48 16 2 0 6.935076 4.455766 6.325405 +49 17 1 0 -8.864042 7.023845 -6.659632 +50 17 2 0 -8.370939 6.372557 -7.141895 +51 17 2 0 -9.489800 7.315873 -7.293125 +52 18 1 0 -4.526299 3.549989 8.030031 +53 18 2 0 -5.169770 4.224127 7.731323 +54 18 2 0 -4.262096 3.801892 8.884875 +55 19 1 0 4.823286 -1.386218 4.038464 +56 19 2 0 5.493155 -0.669965 4.013081 +57 19 2 0 4.187463 -1.101832 3.338433 +58 20 1 0 -2.151150 -2.017060 -8.593685 +59 20 2 0 -2.475709 -2.320356 -7.783564 +60 20 2 0 -2.650484 -2.434614 -9.307384 +61 21 1 0 1.944893 4.933226 0.497910 +62 21 2 0 2.553221 5.263352 1.205303 +63 21 2 0 2.082534 5.590999 -0.202171 +64 22 1 0 -6.827006 -5.285917 -2.371899 +65 22 2 0 -7.405873 -6.022738 -2.075913 +66 22 2 0 -6.398443 -5.453726 -3.235054 +67 23 1 0 -8.538047 -7.577917 -1.688532 +68 23 2 0 -8.075591 -8.448260 -1.513455 +69 23 2 0 -9.389507 -7.836271 -2.051835 +70 24 1 0 -6.916556 -1.100882 -5.168782 +71 24 2 0 -6.365888 -1.659366 -5.746210 +72 24 2 0 -6.538885 -0.249374 -5.325993 +73 25 1 0 6.330290 -9.323893 -6.416630 +74 25 2 0 7.026026 -9.680578 -7.007727 +75 25 2 0 6.812488 -8.683594 -5.925799 +76 26 1 0 -2.424345 -5.918126 2.701855 +77 26 2 0 -1.613829 -5.486394 2.503024 +78 26 2 0 -3.144797 -5.307275 2.618121 +79 27 1 0 0.637202 -6.080457 5.849135 +80 27 2 0 0.892312 -6.092342 4.907709 +81 27 2 0 -0.339074 -5.838972 5.853292 +82 28 1 0 5.199216 -2.264918 -0.138343 +83 28 2 0 5.802838 -2.788698 -0.697536 +84 28 2 0 5.670340 -1.679393 0.462296 +85 29 1 0 0.510145 7.629450 4.054500 +86 29 2 0 -0.071135 8.146563 3.452959 +87 29 2 0 1.464962 7.740819 3.669172 +88 30 1 0 3.146724 8.895843 6.526257 +89 30 2 0 3.506091 8.599906 7.352942 +90 30 2 0 2.145729 8.929622 6.682029 +91 31 1 0 7.308541 -8.339335 -2.471342 +92 31 2 0 6.562127 -8.180601 -3.062803 +93 31 2 0 6.993025 -8.364954 -1.531235 +94 32 1 0 -7.530792 1.069683 4.989387 +95 32 2 0 -7.565406 1.971422 4.648636 +96 32 2 0 -7.938250 0.433547 4.370266 +97 33 1 0 4.452035 2.700609 -5.437815 +98 33 2 0 4.603326 3.058652 -4.551590 +99 33 2 0 4.386453 1.737004 -5.180419 +100 34 1 0 8.427922 -8.619286 1.784691 +101 34 2 0 8.340498 -8.005342 2.536225 +102 34 2 0 8.496720 -9.530562 2.174667 +103 35 1 0 -8.109456 1.753830 -3.096997 +104 35 2 0 -7.245287 1.827177 -2.721417 +105 35 2 0 -8.082178 1.783171 -4.059329 +106 36 1 0 2.776933 -5.701955 7.748213 +107 36 2 0 3.287974 -5.069688 7.233816 +108 36 2 0 1.987041 -5.817355 7.200131 +109 37 1 0 3.635171 -6.953519 5.339628 +110 37 2 0 3.353851 -7.592789 6.031367 +111 37 2 0 2.875801 -6.787975 4.740576 +112 38 1 0 6.888027 -4.169023 -1.800190 +113 38 2 0 7.559735 -4.813701 -2.004669 +114 38 2 0 6.603805 -3.759237 -2.626496 +115 39 1 0 -4.470837 -4.105640 3.415362 +116 39 2 0 -4.991607 -3.358538 3.140956 +117 39 2 0 -4.791764 -4.392214 4.254387 +118 40 1 0 8.282263 -0.462068 -2.560579 +119 40 2 0 8.776769 -1.293641 -2.335945 +120 40 2 0 8.760297 0.384816 -2.651128 +121 41 1 0 4.737236 1.616430 4.901115 +122 41 2 0 3.969692 2.168368 5.152631 +123 41 2 0 5.184651 2.148403 4.154746 +124 42 1 0 -3.497332 -5.781436 -2.202713 +125 42 2 0 -4.038857 -5.773824 -1.381680 +126 42 2 0 -4.152970 -6.012265 -2.829379 +127 43 1 0 -2.863989 -0.259334 -1.857006 +128 43 2 0 -2.132201 -0.027953 -1.174211 +129 43 2 0 -2.873625 -1.224425 -1.874253 +130 44 1 0 1.138300 1.133100 -2.085899 +131 44 2 0 1.965506 1.503520 -1.725316 +132 44 2 0 0.420521 1.534440 -1.551356 +133 45 1 0 -0.561328 4.590705 -2.780017 +134 45 2 0 -0.061173 3.919356 -3.294128 +135 45 2 0 -0.082763 4.733898 -1.955602 +136 46 1 0 -6.423002 -1.705204 -2.528225 +137 46 2 0 -7.233989 -1.949552 -1.975418 +138 46 2 0 -6.678416 -1.321413 -3.351278 +139 47 1 0 -2.772100 2.552210 -0.672282 +140 47 2 0 -2.907489 3.483552 -0.385605 +141 47 2 0 -2.977127 2.592348 -1.635820 +142 48 1 0 6.708678 -4.852016 -8.379280 +143 48 2 0 6.593474 -5.094964 -7.447187 +144 48 2 0 6.582524 -5.591596 -8.966502 +145 49 1 0 -8.497001 -0.440284 2.803721 +146 49 2 0 -8.422350 0.331961 2.183451 +147 49 2 0 -9.377295 -0.756160 2.677026 +148 50 1 0 2.975383 -0.894970 6.060783 +149 50 2 0 2.093991 -0.995700 5.670129 +150 50 2 0 3.458832 -0.759248 5.263958 +151 51 1 0 -6.085023 -1.629620 7.970284 +152 51 2 0 -6.685848 -2.391830 7.820849 +153 51 2 0 -6.177296 -1.190584 8.835912 +154 52 1 0 -3.763523 -3.356777 8.285436 +155 52 2 0 -4.660650 -3.029414 8.406662 +156 52 2 0 -3.411834 -3.178947 7.431180 +157 53 1 0 -1.100120 -0.320162 0.375372 +158 53 2 0 -0.527013 -1.012183 0.128652 +159 53 2 0 -0.673226 0.288559 0.934677 +160 54 1 0 0.910209 -8.271802 1.411429 +161 54 2 0 0.158544 -8.759532 1.870895 +162 54 2 0 0.565924 -7.546113 0.944383 +163 55 1 0 1.554065 -6.468033 3.310872 +164 55 2 0 1.362455 -7.162802 2.722340 +165 55 2 0 1.616233 -5.622409 2.872854 +166 56 1 0 0.543127 -1.388652 4.886094 +167 56 2 0 0.110320 -0.665826 5.311239 +168 56 2 0 0.420366 -2.216367 5.267301 +169 57 1 0 1.100526 1.019490 -9.255318 +170 57 2 0 1.460815 0.575286 -8.484128 +171 57 2 0 0.265613 0.594128 -9.297750 +172 58 1 0 -1.842348 2.327827 -5.355326 +173 58 2 0 -1.572941 2.573139 -6.288125 +174 58 2 0 -2.216679 1.439934 -5.361006 +175 59 1 0 2.452307 -2.814686 -6.448759 +176 59 2 0 2.862295 -3.091668 -5.589336 +177 59 2 0 2.913920 -3.262923 -7.181510 +178 60 1 0 -2.207998 -3.112007 5.945795 +179 60 2 0 -1.262203 -3.125339 6.205467 +180 60 2 0 -2.228269 -2.421858 5.220629 +181 61 1 0 5.845471 5.020556 -6.836491 +182 61 2 0 5.557986 5.913737 -6.753889 +183 61 2 0 5.089998 4.459153 -6.661079 +184 62 1 0 -3.421643 4.865553 0.731755 +185 62 2 0 -3.965419 4.458452 1.478214 +186 62 2 0 -3.973445 4.958338 -0.044430 +187 63 1 0 -2.302950 -2.349717 2.112168 +188 63 2 0 -2.576438 -1.873492 2.873191 +189 63 2 0 -1.882868 -1.715106 1.503782 +190 64 1 0 0.305885 4.878766 3.791182 +191 64 2 0 0.299338 5.855407 4.097578 +192 64 2 0 1.169911 4.563497 4.030616 +193 65 1 0 2.925008 -3.664845 -3.607450 +194 65 2 0 3.015896 -3.916618 -2.644267 +195 65 2 0 2.353923 -2.889459 -3.518284 +196 66 1 0 1.111505 -4.070255 -9.085693 +197 66 2 0 2.084905 -4.227348 -9.180249 +198 66 2 0 0.897072 -4.902218 -8.740523 +199 67 1 0 -4.992929 -1.974219 -7.099668 +200 67 2 0 -5.173269 -1.186309 -7.673625 +201 67 2 0 -5.070893 -2.753273 -7.658821 +202 68 1 0 4.730983 1.478420 0.720986 +203 68 2 0 4.271686 1.988265 0.034225 +204 68 2 0 4.117413 0.788607 1.061818 +205 69 1 0 1.421583 -0.176666 -6.729105 +206 69 2 0 1.217660 0.394331 -5.978213 +207 69 2 0 1.948444 -0.877988 -6.400659 +208 70 1 0 -7.093223 -8.541193 4.116187 +209 70 2 0 -7.074252 -8.047477 3.242159 +210 70 2 0 -6.153142 -8.537148 4.455550 +211 71 1 0 8.382540 -6.460958 3.765735 +212 71 2 0 9.258625 -6.141972 4.060763 +213 71 2 0 7.637364 -6.217910 4.407852 +214 72 1 0 -4.320241 4.037137 3.297092 +215 72 2 0 -3.750151 4.141786 4.105470 +216 72 2 0 -5.172925 4.455578 3.488906 +217 73 1 0 5.581877 1.781994 7.505132 +218 73 2 0 5.017196 1.139584 8.120950 +219 73 2 0 5.330781 1.591217 6.595286 +220 74 1 0 -0.734443 1.125031 4.884666 +221 74 2 0 -0.239224 1.540322 4.142070 +222 74 2 0 -0.961628 1.783437 5.554548 +223 75 1 0 6.831005 -9.249970 4.497165 +224 75 2 0 6.836746 -9.068011 5.427146 +225 75 2 0 7.668067 -9.652510 4.249957 +226 76 1 0 2.714055 -3.677581 1.962003 +227 76 2 0 3.333432 -3.851775 2.663540 +228 76 2 0 3.095021 -3.978526 1.102566 +229 77 1 0 -1.364034 -5.762724 -5.514747 +230 77 2 0 -2.238584 -5.409106 -5.314718 +231 77 2 0 -0.948185 -4.908428 -5.559580 +232 78 1 0 -3.623435 -8.061229 1.383141 +233 78 2 0 -3.132847 -7.446722 1.857906 +234 78 2 0 -4.307943 -7.546630 0.933298 +235 79 1 0 5.717894 6.958376 4.528556 +236 79 2 0 5.852657 7.879846 4.341790 +237 79 2 0 6.443636 6.708413 5.135144 +238 80 1 0 8.121415 8.262619 -8.483986 +239 80 2 0 8.585190 8.939651 -8.974230 +240 80 2 0 7.560207 7.748539 -9.044644 +241 81 1 0 -5.111889 -0.352865 5.807903 +242 81 2 0 -5.940048 0.102298 5.569630 +243 81 2 0 -5.349104 -1.014090 6.507582 +244 82 1 0 0.327324 2.563438 0.113251 +245 82 2 0 -0.633994 2.522136 -0.069385 +246 82 2 0 0.724331 3.482989 0.160564 +247 83 1 0 -6.003367 -7.683112 -8.874252 +248 83 2 0 -6.987751 -7.912403 -8.892689 +249 83 2 0 -5.699015 -8.504722 -8.558813 +250 84 1 0 0.789377 -6.357883 -7.563043 +251 84 2 0 -0.151101 -6.341313 -7.440906 +252 84 2 0 1.090881 -5.879281 -6.770796 +253 85 1 0 5.045666 7.219298 -5.151826 +254 85 2 0 5.598994 7.846492 -5.618276 +255 85 2 0 5.480466 6.978976 -4.337211 +256 86 1 0 1.286092 6.990271 -6.806004 +257 86 2 0 0.481329 7.140371 -7.345224 +258 86 2 0 1.716012 7.791024 -6.762706 +259 87 1 0 -3.198783 -9.175883 -6.334156 +260 87 2 0 -3.032721 -8.198157 -6.198635 +261 87 2 0 -3.084774 -9.539992 -5.434969 +262 88 1 0 -2.002554 -5.668583 5.440781 +263 88 2 0 -2.347493 -4.756386 5.542471 +264 88 2 0 -2.133027 -6.049986 4.540349 +265 89 1 0 6.174952 -8.574733 0.210584 +266 89 2 0 5.358389 -8.191902 0.557392 +267 89 2 0 6.760918 -8.561710 0.943985 +268 90 1 0 -6.278610 6.057339 4.042358 +269 90 2 0 -6.169211 6.708022 3.383078 +270 90 2 0 -7.221766 5.771239 4.032205 +271 91 1 0 0.124733 -5.816398 0.203961 +272 91 2 0 0.029974 -5.049468 0.786871 +273 91 2 0 -0.458026 -5.646677 -0.555312 +274 92 1 0 3.839311 -0.064469 8.619720 +275 92 2 0 3.586253 -0.282978 7.705313 +276 92 2 0 3.079936 0.282626 9.065559 +277 93 1 0 7.375986 -1.368885 4.452411 +278 93 2 0 8.024931 -0.682735 4.768078 +279 93 2 0 7.477247 -1.279372 3.493009 +280 94 1 0 9.209092 -1.611532 -6.423337 +281 94 2 0 9.487648 -2.470973 -6.800897 +282 94 2 0 9.998917 -1.354277 -5.866779 +283 95 1 0 -5.314625 -5.613762 7.941745 +284 95 2 0 -5.589748 -6.389969 8.478078 +285 95 2 0 -4.444519 -5.357513 8.149460 +286 96 1 0 -3.655884 2.941259 -3.295211 +287 96 2 0 -4.418712 2.528163 -3.712668 +288 96 2 0 -2.937568 3.025005 -3.971189 +289 97 1 0 -8.786626 -3.149090 -1.640379 +290 97 2 0 -8.441651 -4.011755 -1.901885 +291 97 2 0 -9.285717 -3.276173 -0.834535 +292 98 1 0 -7.358188 8.239942 -2.093781 +293 98 2 0 -7.811518 7.751233 -2.768278 +294 98 2 0 -6.892430 7.625331 -1.541437 +295 99 1 0 3.770974 -0.453172 -1.931225 +296 99 2 0 4.245757 -0.966218 -1.286114 +297 99 2 0 3.797803 0.441972 -1.542180 +298 100 1 0 2.205813 4.098894 8.958738 +299 100 2 0 3.001973 3.555440 8.746430 +300 100 2 0 2.103639 4.243668 9.940011 +301 101 1 0 -8.723398 -8.284874 -8.890692 +302 101 2 0 -9.298972 -7.537539 -9.239127 +303 101 2 0 -8.772683 -8.361037 -7.925940 +304 102 1 0 -8.908952 0.807167 -7.785764 +305 102 2 0 -9.061230 -0.061912 -7.422589 +306 102 2 0 -9.534219 1.030144 -8.475490 +307 103 1 0 9.182207 -3.418263 -8.430667 +308 103 2 0 9.046738 -2.558299 -8.879898 +309 103 2 0 8.390804 -3.958734 -8.701949 +310 104 1 0 1.003162 9.279867 -8.313986 +311 104 2 0 1.167271 10.190392 -8.070619 +312 104 2 0 1.849962 8.761188 -8.493178 +313 105 1 0 -1.842572 4.893383 8.198130 +314 105 2 0 -2.468210 5.316242 8.833179 +315 105 2 0 -1.155294 4.389410 8.716281 +316 106 1 0 -4.005055 -3.953707 0.402347 +317 106 2 0 -3.682148 -3.305443 1.058769 +318 106 2 0 -4.738199 -4.452434 0.841144 +319 107 1 0 3.511815 -7.590537 -9.004707 +320 107 2 0 3.415066 -7.281286 -8.094635 +321 107 2 0 3.251550 -6.835442 -9.579171 +322 108 1 0 -7.614136 -7.773463 1.262079 +323 108 2 0 -7.489497 -6.927033 0.753779 +324 108 2 0 -8.528840 -8.050689 1.164710 +325 109 1 0 -5.419143 7.061880 -5.745275 +326 109 2 0 -4.504905 6.840455 -5.750772 +327 109 2 0 -5.895918 6.221393 -5.676189 +328 110 1 0 -9.017162 1.888781 0.937813 +329 110 2 0 -9.868157 2.115056 0.623903 +330 110 2 0 -8.466599 1.708818 0.191067 +331 111 1 0 -8.037596 -5.106016 4.750802 +332 111 2 0 -7.322228 -5.707104 5.043673 +333 111 2 0 -8.230169 -4.481051 5.475067 +334 112 1 0 -4.390546 1.691502 -7.756245 +335 112 2 0 -3.558844 1.264966 -7.996466 +336 112 2 0 -4.136121 2.629917 -7.760619 +337 113 1 0 -3.975194 -6.218233 -6.927330 +338 113 2 0 -3.085645 -6.066352 -7.325296 +339 113 2 0 -4.640815 -6.676349 -7.524295 +340 114 1 0 8.240648 5.082183 -8.857912 +341 114 2 0 7.453645 5.101728 -8.259448 +342 114 2 0 8.368223 4.228825 -9.227974 +343 115 1 0 1.598931 -1.829796 -0.316752 +344 115 2 0 1.992252 -1.475465 -1.149815 +345 115 2 0 1.726926 -2.749881 -0.397199 +346 116 1 0 1.433819 -1.386702 -3.304673 +347 116 2 0 1.323094 -0.486757 -3.067110 +348 116 2 0 0.623143 -1.802016 -3.264828 +349 117 1 0 3.735991 5.554990 6.219603 +350 117 2 0 3.320916 6.265941 6.761937 +351 117 2 0 4.195666 6.053207 5.526652 +352 118 1 0 -6.285976 -9.228132 -4.460410 +353 118 2 0 -5.683885 -10.005163 -4.740870 +354 118 2 0 -6.707036 -9.488426 -3.608438 +355 119 1 0 4.036200 -3.378299 6.905724 +356 119 2 0 3.457441 -2.618106 6.794504 +357 119 2 0 4.929409 -2.991177 6.666963 +358 120 1 0 0.606517 8.561279 -3.782406 +359 120 2 0 0.498099 9.526035 -3.699299 +360 120 2 0 1.288545 8.500162 -4.475972 +361 121 1 0 -5.666717 8.368298 -8.299623 +362 121 2 0 -4.926661 7.904359 -8.744783 +363 121 2 0 -5.742748 8.095703 -7.389592 +364 122 1 0 -3.344692 7.636718 3.475830 +365 122 2 0 -4.140634 7.105012 3.296472 +366 122 2 0 -3.350797 7.470949 4.433350 +367 123 1 0 -1.322186 6.638182 0.028906 +368 123 2 0 -1.895088 6.054034 0.554933 +369 123 2 0 -1.928852 7.271511 -0.442137 +370 124 1 0 8.793551 6.925450 7.841717 +371 124 2 0 9.639675 7.325848 7.850680 +372 124 2 0 8.776882 6.398711 8.674036 +373 125 1 0 -6.322101 0.607808 1.174099 +374 125 2 0 -5.647986 1.150825 1.588348 +375 125 2 0 -5.852992 -0.060471 0.660730 +376 126 1 0 5.685139 -3.546046 -4.128549 +377 126 2 0 4.727966 -3.473549 -4.165755 +378 126 2 0 6.024761 -2.749532 -4.610993 +379 127 1 0 3.821999 6.538527 1.678030 +380 127 2 0 3.549684 7.331168 1.175762 +381 127 2 0 3.816423 6.788603 2.602522 +382 128 1 0 3.892622 -7.034239 -6.415978 +383 128 2 0 4.720509 -6.539827 -6.295004 +384 128 2 0 3.262810 -6.550918 -5.890370 +385 129 1 0 5.454437 3.881722 -2.767521 +386 129 2 0 5.906266 3.240489 -3.272250 +387 129 2 0 6.116652 4.657253 -2.669082 +388 130 1 0 -4.179373 -8.326009 4.395005 +389 130 2 0 -3.737878 -8.754475 5.134173 +390 130 2 0 -3.934584 -8.825320 3.534465 +391 131 1 0 7.949488 -1.353498 9.244688 +392 131 2 0 7.234465 -1.100736 9.869694 +393 131 2 0 8.010855 -0.754076 8.476271 +394 132 1 0 4.498603 -4.219267 3.963173 +395 132 2 0 4.895226 -3.311215 4.147093 +396 132 2 0 4.802371 -4.871698 4.671292 +397 133 1 0 -4.307250 7.384668 -2.879462 +398 133 2 0 -3.402854 7.237543 -3.252031 +399 133 2 0 -4.143231 7.834459 -2.019767 +400 134 1 0 2.868752 -0.418389 1.909340 +401 134 2 0 2.544472 -0.880398 1.179279 +402 134 2 0 2.082841 -0.227627 2.457964 +403 135 1 0 7.961389 1.611971 4.525253 +404 135 2 0 7.498497 1.833174 3.728113 +405 135 2 0 8.841880 2.050996 4.576281 +406 136 1 0 2.692467 -4.517946 -0.884665 +407 136 2 0 1.789435 -4.835617 -0.587396 +408 136 2 0 3.330887 -5.126025 -0.474679 +409 137 1 0 0.711797 1.680547 -4.780435 +410 137 2 0 0.854596 1.567911 -3.850059 +411 137 2 0 -0.187286 1.868256 -4.936632 +412 138 1 0 4.558200 -0.044434 -4.673875 +413 138 2 0 5.376141 -0.551202 -4.913295 +414 138 2 0 4.409600 -0.197728 -3.739555 +415 139 1 0 7.109730 0.453475 -0.268844 +416 139 2 0 6.996444 0.098599 -1.119484 +417 139 2 0 6.343115 1.050849 -0.110689 +418 140 1 0 -2.549577 -0.200852 -4.492507 +419 140 2 0 -3.199039 -0.856439 -4.888752 +420 140 2 0 -2.605120 -0.151501 -3.534000 +421 141 1 0 -8.527353 4.524174 -2.347408 +422 141 2 0 -7.662213 4.342466 -2.104852 +423 141 2 0 -8.794374 3.696793 -2.795740 +424 142 1 0 -2.820431 -0.700478 4.413266 +425 142 2 0 -2.088343 -0.069797 4.530521 +426 142 2 0 -3.535913 -0.413547 5.069151 +427 143 1 0 6.924598 -1.285634 -4.901833 +428 143 2 0 7.496477 -0.831510 -4.206076 +429 143 2 0 7.527035 -1.446676 -5.677236 +430 144 1 0 -5.353763 6.572088 6.734366 +431 144 2 0 -4.428432 6.663173 6.834862 +432 144 2 0 -5.603600 6.385787 5.822425 +433 145 1 0 7.661597 2.386104 9.175259 +434 145 2 0 7.321694 2.395921 10.055536 +435 145 2 0 6.959141 2.102200 8.533079 +436 146 1 0 -3.496590 -3.765912 -4.994838 +437 146 2 0 -3.612181 -3.620689 -4.036115 +438 146 2 0 -4.323649 -3.527816 -5.463213 +439 147 1 0 -9.351953 8.343146 3.704719 +440 147 2 0 -8.465363 8.758592 3.736785 +441 147 2 0 -9.159223 7.399420 3.880808 +442 148 1 0 -0.957571 -5.174275 -2.190170 +443 148 2 0 -1.907345 -5.209294 -2.303164 +444 148 2 0 -0.758582 -4.314608 -2.636469 +445 149 1 0 5.048831 -7.988284 2.587515 +446 149 2 0 5.870168 -8.296198 3.043816 +447 149 2 0 4.551970 -7.498875 3.229280 +448 150 1 0 3.705658 8.368298 -8.304931 +449 150 2 0 3.860607 9.297256 -8.425405 +450 150 2 0 3.866516 8.146007 -7.371475 +451 151 1 0 -2.535134 7.116414 6.338590 +452 151 2 0 -1.918884 7.705593 6.804078 +453 151 2 0 -1.975225 6.330832 6.121365 +454 152 1 0 -3.440263 7.005018 9.111704 +455 152 2 0 -2.633953 7.421761 9.465848 +456 152 2 0 -3.654896 7.513753 8.256470 +457 153 1 0 6.452501 -5.478051 -5.722874 +458 153 2 0 7.297698 -5.914122 -5.586895 +459 153 2 0 6.253267 -4.919338 -4.937095 +460 154 1 0 -6.528475 4.497861 -5.573636 +461 154 2 0 -6.257840 4.684056 -4.656222 +462 154 2 0 -7.247764 3.931701 -5.623068 +463 155 1 0 -7.310706 8.183648 7.852201 +464 155 2 0 -6.552879 7.735013 7.436342 +465 155 2 0 -6.877865 8.451022 8.686616 +466 156 1 0 -1.476441 -7.867001 7.421787 +467 156 2 0 -0.852398 -8.570669 7.084405 +468 156 2 0 -1.363740 -7.190554 6.737331 +469 157 1 0 5.228019 -0.495870 -7.592953 +470 157 2 0 4.737616 -0.538139 -6.742036 +471 157 2 0 4.625354 -0.901329 -8.269022 +472 158 1 0 7.566531 -1.006734 1.808213 +473 158 2 0 7.657411 -1.866188 1.428564 +474 158 2 0 7.358547 -0.388051 1.139943 +475 159 1 0 1.850924 -5.717449 -5.035416 +476 159 2 0 1.721040 -6.227449 -4.217213 +477 159 2 0 2.199319 -4.856378 -4.692892 +478 160 1 0 -8.904325 6.791585 -3.842866 +479 160 2 0 -8.690637 5.952112 -3.490118 +480 160 2 0 -8.676001 6.844077 -4.770651 +481 161 1 0 -3.434304 4.397198 -7.863568 +482 161 2 0 -2.634777 3.892027 -7.779256 +483 161 2 0 -3.432847 5.161485 -7.310788 +484 162 1 0 -7.446738 6.124823 0.150068 +485 162 2 0 -7.404893 5.207959 0.481504 +486 162 2 0 -8.405563 6.215466 -0.024439 +487 163 1 0 0.195330 -7.307128 -3.501714 +488 163 2 0 -0.240912 -6.769004 -4.243655 +489 163 2 0 -0.194915 -6.981989 -2.679860 +490 164 1 0 7.068819 9.130323 7.260588 +491 164 2 0 6.559855 8.400987 7.699406 +492 164 2 0 7.972497 8.829223 7.213747 +493 165 1 0 -0.185218 -3.192290 -6.289346 +494 165 2 0 0.776651 -3.073203 -6.391948 +495 165 2 0 -0.497426 -2.964088 -7.170893 +496 166 1 0 -2.073630 4.369672 5.251074 +497 166 2 0 -1.868638 3.811508 6.060261 +498 166 2 0 -1.253174 4.326708 4.781680 +499 167 1 0 -0.855003 3.069108 -7.935226 +500 167 2 0 0.075758 3.132202 -7.617253 +501 167 2 0 -1.009845 2.207487 -8.320426 +502 168 1 0 -6.328833 0.064083 -8.467228 +503 168 2 0 -7.268416 0.384648 -8.383978 +504 168 2 0 -5.825246 0.919304 -8.320175 +505 169 1 0 -8.276352 -8.809851 -6.344910 +506 169 2 0 -7.541457 -8.792368 -5.688031 +507 169 2 0 -8.510208 -9.731116 -6.353248 +508 170 1 0 0.463654 2.826776 7.018388 +509 170 2 0 0.875324 3.588447 7.482107 +510 170 2 0 0.770257 2.126646 7.583650 +511 171 1 0 0.478371 -3.407198 6.910039 +512 171 2 0 0.585298 -2.996750 7.756467 +513 171 2 0 0.556531 -4.390636 7.183527 +514 172 1 0 -1.689559 7.002511 -3.303561 +515 172 2 0 -1.009152 7.635432 -3.553133 +516 172 2 0 -1.333699 6.195680 -2.919485 +517 173 1 0 9.000097 -6.227871 8.137681 +518 173 2 0 9.373858 -6.821152 7.497417 +519 173 2 0 8.024020 -6.011019 8.033727 +520 174 1 0 1.272378 1.954065 3.058033 +521 174 2 0 1.260842 2.615112 2.341207 +522 174 2 0 1.890312 2.223439 3.732934 +523 175 1 0 4.139066 -3.527427 -9.022609 +524 175 2 0 4.070028 -3.499117 -9.985525 +525 175 2 0 4.960292 -3.942364 -8.778433 +526 176 1 0 7.176276 2.178662 -4.075940 +527 176 2 0 6.995275 1.684022 -4.873223 +528 176 2 0 7.621313 2.984315 -4.393994 +529 177 1 0 -0.034836 -3.929919 2.148095 +530 177 2 0 0.838003 -3.513346 2.259663 +531 177 2 0 -0.654999 -3.288581 2.426748 +532 178 1 0 -8.701616 2.795237 -5.700842 +533 178 2 0 -8.848959 2.145603 -6.420186 +534 178 2 0 -9.464654 3.362988 -5.610379 +535 179 1 0 2.804444 8.909551 -5.635389 +536 179 2 0 3.063615 9.805993 -5.770957 +537 179 2 0 3.512196 8.486179 -5.165468 +538 180 1 0 3.236002 8.357402 3.636639 +539 180 2 0 3.450854 9.071799 3.073263 +540 180 2 0 3.476445 8.586691 4.607935 +541 181 1 0 5.628532 7.185941 8.510937 +542 181 2 0 5.467837 6.318153 8.138885 +543 181 2 0 4.964153 7.477925 9.150467 +544 182 1 0 -3.767261 1.260390 2.017681 +545 182 2 0 -3.707734 2.019520 2.565591 +546 182 2 0 -3.364602 1.609935 1.212351 +547 183 1 0 8.228917 -3.441761 0.850139 +548 183 2 0 9.022130 -3.709208 1.334881 +549 183 2 0 7.553662 -3.976731 1.276651 +550 184 1 0 -3.004292 1.345869 7.236734 +551 184 2 0 -3.715311 0.724731 6.912689 +552 184 2 0 -3.525684 2.111901 7.538936 +553 185 1 0 4.901423 -5.547141 -0.119795 +554 185 2 0 5.327550 -5.560969 0.769770 +555 185 2 0 5.447642 -4.930752 -0.617088 +556 186 1 0 -3.306210 8.469477 -0.495057 +557 186 2 0 -2.836855 9.122642 -1.080706 +558 186 2 0 -3.311215 8.916887 0.353875 +559 187 1 0 -6.572180 3.018421 -0.262079 +560 187 2 0 -6.711444 2.659956 0.606460 +561 187 2 0 -6.040782 2.473886 -0.843542 +562 188 1 0 -5.429147 -5.967833 5.177682 +563 188 2 0 -4.896648 -6.608203 4.692534 +564 188 2 0 -5.386594 -6.130690 6.117931 +565 189 1 0 6.054430 7.035601 0.031519 +566 189 2 0 5.939348 7.951184 -0.141094 +567 189 2 0 5.390949 6.866654 0.702638 +568 190 1 0 -0.890229 -2.615376 -3.621726 +569 190 2 0 -1.695442 -2.097314 -3.537976 +570 190 2 0 -0.895128 -2.637531 -4.561712 +571 191 1 0 -5.446979 0.994907 -2.106714 +572 191 2 0 -4.494883 0.997912 -1.881595 +573 191 2 0 -5.759736 0.094199 -1.919247 +574 192 1 0 -7.517688 -4.078340 7.202707 +575 192 2 0 -8.242348 -4.324693 7.729813 +576 192 2 0 -6.924399 -4.817453 7.269430 +577 193 1 0 -1.134884 8.628488 2.081069 +578 193 2 0 -1.962897 8.634713 2.554947 +579 193 2 0 -1.119731 7.882422 1.516003 +580 194 1 0 -6.288317 8.011683 2.022129 +581 194 2 0 -6.404647 8.858198 1.546109 +582 194 2 0 -6.669138 7.315199 1.482614 +583 195 1 0 -6.766934 -4.026505 -8.306645 +584 195 2 0 -6.542552 -4.855702 -8.828363 +585 195 2 0 -7.743726 -3.954163 -8.170031 +586 196 1 0 6.895244 7.052113 -3.031289 +587 196 2 0 7.810039 7.265357 -3.330751 +588 196 2 0 6.666757 7.541675 -2.202178 +589 197 1 0 8.003260 4.735929 -5.168656 +590 197 2 0 7.233375 4.730204 -5.685772 +591 197 2 0 8.406708 5.629580 -5.300038 +592 198 1 0 -5.230160 -6.461196 -4.390836 +593 198 2 0 -5.701559 -7.313756 -4.377348 +594 198 2 0 -4.855545 -6.327970 -5.273444 +595 199 1 0 -3.803496 -9.221115 7.305476 +596 199 2 0 -2.934288 -8.877999 7.425047 +597 199 2 0 -4.416066 -8.566250 7.573191 +598 200 1 0 -5.990438 -1.574415 3.072521 +599 200 2 0 -5.805447 -1.119293 3.933731 +600 200 2 0 -6.651651 -0.947206 2.634773 +601 201 1 0 1.155451 7.138377 -1.178317 +602 201 2 0 0.330359 7.363227 -0.724568 +603 201 2 0 1.055145 7.478676 -2.100793 +604 202 1 0 -5.886817 5.150957 -2.997276 +605 202 2 0 -5.191777 4.556623 -2.611465 +606 202 2 0 -5.401622 6.003350 -3.064194 +607 203 1 0 2.539927 3.387568 4.976180 +608 203 2 0 1.760904 3.182324 5.589217 +609 203 2 0 2.841539 4.315465 5.278853 +610 204 1 0 8.331859 -7.344673 -5.188191 +611 204 2 0 8.424401 -7.586778 -4.198621 +612 204 2 0 8.911675 -7.764424 -5.823267 +613 205 1 0 -5.774081 1.315144 -5.304553 +614 205 2 0 -5.222992 1.580336 -6.077077 +615 205 2 0 -6.219878 2.178441 -5.093360 +616 206 1 0 6.340084 -4.926064 2.149626 +617 206 2 0 5.639784 -4.766017 2.829591 +618 206 2 0 6.883511 -5.598794 2.562820 +619 207 1 0 -2.722394 6.614441 -5.843805 +620 207 2 0 -2.332414 7.251953 -6.403722 +621 207 2 0 -2.221682 6.596615 -5.034993 +622 208 1 0 -1.813152 0.712824 -9.048176 +623 208 2 0 -1.763921 -0.271744 -8.916841 +624 208 2 0 -2.097796 0.860500 -9.970314 +625 209 1 0 6.146244 -6.879929 8.376712 +626 209 2 0 5.324465 -7.183905 8.841506 +627 209 2 0 6.642264 -7.749945 8.201756 +628 210 1 0 2.887544 8.612615 0.453821 +629 210 2 0 2.452117 8.047637 -0.251289 +630 210 2 0 2.348751 9.285636 0.895642 +631 211 1 0 -8.475558 -8.180718 6.501232 +632 211 2 0 -8.034310 -8.945692 6.891221 +633 211 2 0 -8.173606 -8.179435 5.569319 +634 212 1 0 6.714205 -2.947903 6.551671 +635 212 2 0 7.143284 -2.459194 7.270891 +636 212 2 0 7.212365 -2.637046 5.791018 +637 213 1 0 6.445003 -5.462306 5.577966 +638 213 2 0 6.730099 -4.696457 6.073312 +639 213 2 0 6.099428 -6.099736 6.222859 +640 214 1 0 -1.818761 -6.080111 -8.805420 +641 214 2 0 -1.644534 -6.777931 -9.477669 +642 214 2 0 -2.078582 -5.258591 -9.215838 +643 215 1 0 6.037377 2.950576 2.863541 +644 215 2 0 6.409766 3.757001 2.570754 +645 215 2 0 5.577033 2.617474 2.090587 +646 216 1 0 -7.731645 3.337668 3.301121 +647 216 2 0 -8.345957 4.027222 3.589257 +648 216 2 0 -8.130328 2.845238 2.577949 + +Bonds + +1 1 1 2 +2 1 1 3 +3 1 4 5 +4 1 4 6 +5 1 7 8 +6 1 7 9 +7 1 10 11 +8 1 10 12 +9 1 13 14 +10 1 13 15 +11 1 16 17 +12 1 16 18 +13 1 19 20 +14 1 19 21 +15 1 22 23 +16 1 22 24 +17 1 25 26 +18 1 25 27 +19 1 28 29 +20 1 28 30 +21 1 31 32 +22 1 31 33 +23 1 34 35 +24 1 34 36 +25 1 37 38 +26 1 37 39 +27 1 40 41 +28 1 40 42 +29 1 43 44 +30 1 43 45 +31 1 46 47 +32 1 46 48 +33 1 49 50 +34 1 49 51 +35 1 52 53 +36 1 52 54 +37 1 55 56 +38 1 55 57 +39 1 58 59 +40 1 58 60 +41 1 61 62 +42 1 61 63 +43 1 64 65 +44 1 64 66 +45 1 67 68 +46 1 67 69 +47 1 70 71 +48 1 70 72 +49 1 73 74 +50 1 73 75 +51 1 76 77 +52 1 76 78 +53 1 79 80 +54 1 79 81 +55 1 82 83 +56 1 82 84 +57 1 85 86 +58 1 85 87 +59 1 88 89 +60 1 88 90 +61 1 91 92 +62 1 91 93 +63 1 94 95 +64 1 94 96 +65 1 97 98 +66 1 97 99 +67 1 100 101 +68 1 100 102 +69 1 103 104 +70 1 103 105 +71 1 106 107 +72 1 106 108 +73 1 109 110 +74 1 109 111 +75 1 112 113 +76 1 112 114 +77 1 115 116 +78 1 115 117 +79 1 118 119 +80 1 118 120 +81 1 121 122 +82 1 121 123 +83 1 124 125 +84 1 124 126 +85 1 127 128 +86 1 127 129 +87 1 130 131 +88 1 130 132 +89 1 133 134 +90 1 133 135 +91 1 136 137 +92 1 136 138 +93 1 139 140 +94 1 139 141 +95 1 142 143 +96 1 142 144 +97 1 145 146 +98 1 145 147 +99 1 148 149 +100 1 148 150 +101 1 151 152 +102 1 151 153 +103 1 154 155 +104 1 154 156 +105 1 157 158 +106 1 157 159 +107 1 160 161 +108 1 160 162 +109 1 163 164 +110 1 163 165 +111 1 166 167 +112 1 166 168 +113 1 169 170 +114 1 169 171 +115 1 172 173 +116 1 172 174 +117 1 175 176 +118 1 175 177 +119 1 178 179 +120 1 178 180 +121 1 181 182 +122 1 181 183 +123 1 184 185 +124 1 184 186 +125 1 187 188 +126 1 187 189 +127 1 190 191 +128 1 190 192 +129 1 193 194 +130 1 193 195 +131 1 196 197 +132 1 196 198 +133 1 199 200 +134 1 199 201 +135 1 202 203 +136 1 202 204 +137 1 205 206 +138 1 205 207 +139 1 208 209 +140 1 208 210 +141 1 211 212 +142 1 211 213 +143 1 214 215 +144 1 214 216 +145 1 217 218 +146 1 217 219 +147 1 220 221 +148 1 220 222 +149 1 223 224 +150 1 223 225 +151 1 226 227 +152 1 226 228 +153 1 229 230 +154 1 229 231 +155 1 232 233 +156 1 232 234 +157 1 235 236 +158 1 235 237 +159 1 238 239 +160 1 238 240 +161 1 241 242 +162 1 241 243 +163 1 244 245 +164 1 244 246 +165 1 247 248 +166 1 247 249 +167 1 250 251 +168 1 250 252 +169 1 253 254 +170 1 253 255 +171 1 256 257 +172 1 256 258 +173 1 259 260 +174 1 259 261 +175 1 262 263 +176 1 262 264 +177 1 265 266 +178 1 265 267 +179 1 268 269 +180 1 268 270 +181 1 271 272 +182 1 271 273 +183 1 274 275 +184 1 274 276 +185 1 277 278 +186 1 277 279 +187 1 280 281 +188 1 280 282 +189 1 283 284 +190 1 283 285 +191 1 286 287 +192 1 286 288 +193 1 289 290 +194 1 289 291 +195 1 292 293 +196 1 292 294 +197 1 295 296 +198 1 295 297 +199 1 298 299 +200 1 298 300 +201 1 301 302 +202 1 301 303 +203 1 304 305 +204 1 304 306 +205 1 307 308 +206 1 307 309 +207 1 310 311 +208 1 310 312 +209 1 313 314 +210 1 313 315 +211 1 316 317 +212 1 316 318 +213 1 319 320 +214 1 319 321 +215 1 322 323 +216 1 322 324 +217 1 325 326 +218 1 325 327 +219 1 328 329 +220 1 328 330 +221 1 331 332 +222 1 331 333 +223 1 334 335 +224 1 334 336 +225 1 337 338 +226 1 337 339 +227 1 340 341 +228 1 340 342 +229 1 343 344 +230 1 343 345 +231 1 346 347 +232 1 346 348 +233 1 349 350 +234 1 349 351 +235 1 352 353 +236 1 352 354 +237 1 355 356 +238 1 355 357 +239 1 358 359 +240 1 358 360 +241 1 361 362 +242 1 361 363 +243 1 364 365 +244 1 364 366 +245 1 367 368 +246 1 367 369 +247 1 370 371 +248 1 370 372 +249 1 373 374 +250 1 373 375 +251 1 376 377 +252 1 376 378 +253 1 379 380 +254 1 379 381 +255 1 382 383 +256 1 382 384 +257 1 385 386 +258 1 385 387 +259 1 388 389 +260 1 388 390 +261 1 391 392 +262 1 391 393 +263 1 394 395 +264 1 394 396 +265 1 397 398 +266 1 397 399 +267 1 400 401 +268 1 400 402 +269 1 403 404 +270 1 403 405 +271 1 406 407 +272 1 406 408 +273 1 409 410 +274 1 409 411 +275 1 412 413 +276 1 412 414 +277 1 415 416 +278 1 415 417 +279 1 418 419 +280 1 418 420 +281 1 421 422 +282 1 421 423 +283 1 424 425 +284 1 424 426 +285 1 427 428 +286 1 427 429 +287 1 430 431 +288 1 430 432 +289 1 433 434 +290 1 433 435 +291 1 436 437 +292 1 436 438 +293 1 439 440 +294 1 439 441 +295 1 442 443 +296 1 442 444 +297 1 445 446 +298 1 445 447 +299 1 448 449 +300 1 448 450 +301 1 451 452 +302 1 451 453 +303 1 454 455 +304 1 454 456 +305 1 457 458 +306 1 457 459 +307 1 460 461 +308 1 460 462 +309 1 463 464 +310 1 463 465 +311 1 466 467 +312 1 466 468 +313 1 469 470 +314 1 469 471 +315 1 472 473 +316 1 472 474 +317 1 475 476 +318 1 475 477 +319 1 478 479 +320 1 478 480 +321 1 481 482 +322 1 481 483 +323 1 484 485 +324 1 484 486 +325 1 487 488 +326 1 487 489 +327 1 490 491 +328 1 490 492 +329 1 493 494 +330 1 493 495 +331 1 496 497 +332 1 496 498 +333 1 499 500 +334 1 499 501 +335 1 502 503 +336 1 502 504 +337 1 505 506 +338 1 505 507 +339 1 508 509 +340 1 508 510 +341 1 511 512 +342 1 511 513 +343 1 514 515 +344 1 514 516 +345 1 517 518 +346 1 517 519 +347 1 520 521 +348 1 520 522 +349 1 523 524 +350 1 523 525 +351 1 526 527 +352 1 526 528 +353 1 529 530 +354 1 529 531 +355 1 532 533 +356 1 532 534 +357 1 535 536 +358 1 535 537 +359 1 538 539 +360 1 538 540 +361 1 541 542 +362 1 541 543 +363 1 544 545 +364 1 544 546 +365 1 547 548 +366 1 547 549 +367 1 550 551 +368 1 550 552 +369 1 553 554 +370 1 553 555 +371 1 556 557 +372 1 556 558 +373 1 559 560 +374 1 559 561 +375 1 562 563 +376 1 562 564 +377 1 565 566 +378 1 565 567 +379 1 568 569 +380 1 568 570 +381 1 571 572 +382 1 571 573 +383 1 574 575 +384 1 574 576 +385 1 577 578 +386 1 577 579 +387 1 580 581 +388 1 580 582 +389 1 583 584 +390 1 583 585 +391 1 586 587 +392 1 586 588 +393 1 589 590 +394 1 589 591 +395 1 592 593 +396 1 592 594 +397 1 595 596 +398 1 595 597 +399 1 598 599 +400 1 598 600 +401 1 601 602 +402 1 601 603 +403 1 604 605 +404 1 604 606 +405 1 607 608 +406 1 607 609 +407 1 610 611 +408 1 610 612 +409 1 613 614 +410 1 613 615 +411 1 616 617 +412 1 616 618 +413 1 619 620 +414 1 619 621 +415 1 622 623 +416 1 622 624 +417 1 625 626 +418 1 625 627 +419 1 628 629 +420 1 628 630 +421 1 631 632 +422 1 631 633 +423 1 634 635 +424 1 634 636 +425 1 637 638 +426 1 637 639 +427 1 640 641 +428 1 640 642 +429 1 643 644 +430 1 643 645 +431 1 646 647 +432 1 646 648 + +Angles + +1 1 2 1 3 +2 1 5 4 6 +3 1 8 7 9 +4 1 11 10 12 +5 1 14 13 15 +6 1 17 16 18 +7 1 20 19 21 +8 1 23 22 24 +9 1 26 25 27 +10 1 29 28 30 +11 1 32 31 33 +12 1 35 34 36 +13 1 38 37 39 +14 1 41 40 42 +15 1 44 43 45 +16 1 47 46 48 +17 1 50 49 51 +18 1 53 52 54 +19 1 56 55 57 +20 1 59 58 60 +21 1 62 61 63 +22 1 65 64 66 +23 1 68 67 69 +24 1 71 70 72 +25 1 74 73 75 +26 1 77 76 78 +27 1 80 79 81 +28 1 83 82 84 +29 1 86 85 87 +30 1 89 88 90 +31 1 92 91 93 +32 1 95 94 96 +33 1 98 97 99 +34 1 101 100 102 +35 1 104 103 105 +36 1 107 106 108 +37 1 110 109 111 +38 1 113 112 114 +39 1 116 115 117 +40 1 119 118 120 +41 1 122 121 123 +42 1 125 124 126 +43 1 128 127 129 +44 1 131 130 132 +45 1 134 133 135 +46 1 137 136 138 +47 1 140 139 141 +48 1 143 142 144 +49 1 146 145 147 +50 1 149 148 150 +51 1 152 151 153 +52 1 155 154 156 +53 1 158 157 159 +54 1 161 160 162 +55 1 164 163 165 +56 1 167 166 168 +57 1 170 169 171 +58 1 173 172 174 +59 1 176 175 177 +60 1 179 178 180 +61 1 182 181 183 +62 1 185 184 186 +63 1 188 187 189 +64 1 191 190 192 +65 1 194 193 195 +66 1 197 196 198 +67 1 200 199 201 +68 1 203 202 204 +69 1 206 205 207 +70 1 209 208 210 +71 1 212 211 213 +72 1 215 214 216 +73 1 218 217 219 +74 1 221 220 222 +75 1 224 223 225 +76 1 227 226 228 +77 1 230 229 231 +78 1 233 232 234 +79 1 236 235 237 +80 1 239 238 240 +81 1 242 241 243 +82 1 245 244 246 +83 1 248 247 249 +84 1 251 250 252 +85 1 254 253 255 +86 1 257 256 258 +87 1 260 259 261 +88 1 263 262 264 +89 1 266 265 267 +90 1 269 268 270 +91 1 272 271 273 +92 1 275 274 276 +93 1 278 277 279 +94 1 281 280 282 +95 1 284 283 285 +96 1 287 286 288 +97 1 290 289 291 +98 1 293 292 294 +99 1 296 295 297 +100 1 299 298 300 +101 1 302 301 303 +102 1 305 304 306 +103 1 308 307 309 +104 1 311 310 312 +105 1 314 313 315 +106 1 317 316 318 +107 1 320 319 321 +108 1 323 322 324 +109 1 326 325 327 +110 1 329 328 330 +111 1 332 331 333 +112 1 335 334 336 +113 1 338 337 339 +114 1 341 340 342 +115 1 344 343 345 +116 1 347 346 348 +117 1 350 349 351 +118 1 353 352 354 +119 1 356 355 357 +120 1 359 358 360 +121 1 362 361 363 +122 1 365 364 366 +123 1 368 367 369 +124 1 371 370 372 +125 1 374 373 375 +126 1 377 376 378 +127 1 380 379 381 +128 1 383 382 384 +129 1 386 385 387 +130 1 389 388 390 +131 1 392 391 393 +132 1 395 394 396 +133 1 398 397 399 +134 1 401 400 402 +135 1 404 403 405 +136 1 407 406 408 +137 1 410 409 411 +138 1 413 412 414 +139 1 416 415 417 +140 1 419 418 420 +141 1 422 421 423 +142 1 425 424 426 +143 1 428 427 429 +144 1 431 430 432 +145 1 434 433 435 +146 1 437 436 438 +147 1 440 439 441 +148 1 443 442 444 +149 1 446 445 447 +150 1 449 448 450 +151 1 452 451 453 +152 1 455 454 456 +153 1 458 457 459 +154 1 461 460 462 +155 1 464 463 465 +156 1 467 466 468 +157 1 470 469 471 +158 1 473 472 474 +159 1 476 475 477 +160 1 479 478 480 +161 1 482 481 483 +162 1 485 484 486 +163 1 488 487 489 +164 1 491 490 492 +165 1 494 493 495 +166 1 497 496 498 +167 1 500 499 501 +168 1 503 502 504 +169 1 506 505 507 +170 1 509 508 510 +171 1 512 511 513 +172 1 515 514 516 +173 1 518 517 519 +174 1 521 520 522 +175 1 524 523 525 +176 1 527 526 528 +177 1 530 529 531 +178 1 533 532 534 +179 1 536 535 537 +180 1 539 538 540 +181 1 542 541 543 +182 1 545 544 546 +183 1 548 547 549 +184 1 551 550 552 +185 1 554 553 555 +186 1 557 556 558 +187 1 560 559 561 +188 1 563 562 564 +189 1 566 565 567 +190 1 569 568 570 +191 1 572 571 573 +192 1 575 574 576 +193 1 578 577 579 +194 1 581 580 582 +195 1 584 583 585 +196 1 587 586 588 +197 1 590 589 591 +198 1 593 592 594 +199 1 596 595 597 +200 1 599 598 600 +201 1 602 601 603 +202 1 605 604 606 +203 1 608 607 609 +204 1 611 610 612 +205 1 614 613 615 +206 1 617 616 618 +207 1 620 619 621 +208 1 623 622 624 +209 1 626 625 627 +210 1 629 628 630 +211 1 632 631 633 +212 1 635 634 636 +213 1 638 637 639 +214 1 641 640 642 +215 1 644 643 645 +216 1 647 646 648 + +Bond Coeffs + +1 0.9572 556.85 -1419.9675 2112.20165625 + +Angle Coeffs + +1 0 107.7 48.7 -39.064262472 8.95286947775 -6.41202044508 11.5462823034 + +Tinker Types + +1 1 +2 2 +3 2 +4 1 +5 2 +6 2 +7 1 +8 2 +9 2 +10 1 +11 2 +12 2 +13 1 +14 2 +15 2 +16 1 +17 2 +18 2 +19 1 +20 2 +21 2 +22 1 +23 2 +24 2 +25 1 +26 2 +27 2 +28 1 +29 2 +30 2 +31 1 +32 2 +33 2 +34 1 +35 2 +36 2 +37 1 +38 2 +39 2 +40 1 +41 2 +42 2 +43 1 +44 2 +45 2 +46 1 +47 2 +48 2 +49 1 +50 2 +51 2 +52 1 +53 2 +54 2 +55 1 +56 2 +57 2 +58 1 +59 2 +60 2 +61 1 +62 2 +63 2 +64 1 +65 2 +66 2 +67 1 +68 2 +69 2 +70 1 +71 2 +72 2 +73 1 +74 2 +75 2 +76 1 +77 2 +78 2 +79 1 +80 2 +81 2 +82 1 +83 2 +84 2 +85 1 +86 2 +87 2 +88 1 +89 2 +90 2 +91 1 +92 2 +93 2 +94 1 +95 2 +96 2 +97 1 +98 2 +99 2 +100 1 +101 2 +102 2 +103 1 +104 2 +105 2 +106 1 +107 2 +108 2 +109 1 +110 2 +111 2 +112 1 +113 2 +114 2 +115 1 +116 2 +117 2 +118 1 +119 2 +120 2 +121 1 +122 2 +123 2 +124 1 +125 2 +126 2 +127 1 +128 2 +129 2 +130 1 +131 2 +132 2 +133 1 +134 2 +135 2 +136 1 +137 2 +138 2 +139 1 +140 2 +141 2 +142 1 +143 2 +144 2 +145 1 +146 2 +147 2 +148 1 +149 2 +150 2 +151 1 +152 2 +153 2 +154 1 +155 2 +156 2 +157 1 +158 2 +159 2 +160 1 +161 2 +162 2 +163 1 +164 2 +165 2 +166 1 +167 2 +168 2 +169 1 +170 2 +171 2 +172 1 +173 2 +174 2 +175 1 +176 2 +177 2 +178 1 +179 2 +180 2 +181 1 +182 2 +183 2 +184 1 +185 2 +186 2 +187 1 +188 2 +189 2 +190 1 +191 2 +192 2 +193 1 +194 2 +195 2 +196 1 +197 2 +198 2 +199 1 +200 2 +201 2 +202 1 +203 2 +204 2 +205 1 +206 2 +207 2 +208 1 +209 2 +210 2 +211 1 +212 2 +213 2 +214 1 +215 2 +216 2 +217 1 +218 2 +219 2 +220 1 +221 2 +222 2 +223 1 +224 2 +225 2 +226 1 +227 2 +228 2 +229 1 +230 2 +231 2 +232 1 +233 2 +234 2 +235 1 +236 2 +237 2 +238 1 +239 2 +240 2 +241 1 +242 2 +243 2 +244 1 +245 2 +246 2 +247 1 +248 2 +249 2 +250 1 +251 2 +252 2 +253 1 +254 2 +255 2 +256 1 +257 2 +258 2 +259 1 +260 2 +261 2 +262 1 +263 2 +264 2 +265 1 +266 2 +267 2 +268 1 +269 2 +270 2 +271 1 +272 2 +273 2 +274 1 +275 2 +276 2 +277 1 +278 2 +279 2 +280 1 +281 2 +282 2 +283 1 +284 2 +285 2 +286 1 +287 2 +288 2 +289 1 +290 2 +291 2 +292 1 +293 2 +294 2 +295 1 +296 2 +297 2 +298 1 +299 2 +300 2 +301 1 +302 2 +303 2 +304 1 +305 2 +306 2 +307 1 +308 2 +309 2 +310 1 +311 2 +312 2 +313 1 +314 2 +315 2 +316 1 +317 2 +318 2 +319 1 +320 2 +321 2 +322 1 +323 2 +324 2 +325 1 +326 2 +327 2 +328 1 +329 2 +330 2 +331 1 +332 2 +333 2 +334 1 +335 2 +336 2 +337 1 +338 2 +339 2 +340 1 +341 2 +342 2 +343 1 +344 2 +345 2 +346 1 +347 2 +348 2 +349 1 +350 2 +351 2 +352 1 +353 2 +354 2 +355 1 +356 2 +357 2 +358 1 +359 2 +360 2 +361 1 +362 2 +363 2 +364 1 +365 2 +366 2 +367 1 +368 2 +369 2 +370 1 +371 2 +372 2 +373 1 +374 2 +375 2 +376 1 +377 2 +378 2 +379 1 +380 2 +381 2 +382 1 +383 2 +384 2 +385 1 +386 2 +387 2 +388 1 +389 2 +390 2 +391 1 +392 2 +393 2 +394 1 +395 2 +396 2 +397 1 +398 2 +399 2 +400 1 +401 2 +402 2 +403 1 +404 2 +405 2 +406 1 +407 2 +408 2 +409 1 +410 2 +411 2 +412 1 +413 2 +414 2 +415 1 +416 2 +417 2 +418 1 +419 2 +420 2 +421 1 +422 2 +423 2 +424 1 +425 2 +426 2 +427 1 +428 2 +429 2 +430 1 +431 2 +432 2 +433 1 +434 2 +435 2 +436 1 +437 2 +438 2 +439 1 +440 2 +441 2 +442 1 +443 2 +444 2 +445 1 +446 2 +447 2 +448 1 +449 2 +450 2 +451 1 +452 2 +453 2 +454 1 +455 2 +456 2 +457 1 +458 2 +459 2 +460 1 +461 2 +462 2 +463 1 +464 2 +465 2 +466 1 +467 2 +468 2 +469 1 +470 2 +471 2 +472 1 +473 2 +474 2 +475 1 +476 2 +477 2 +478 1 +479 2 +480 2 +481 1 +482 2 +483 2 +484 1 +485 2 +486 2 +487 1 +488 2 +489 2 +490 1 +491 2 +492 2 +493 1 +494 2 +495 2 +496 1 +497 2 +498 2 +499 1 +500 2 +501 2 +502 1 +503 2 +504 2 +505 1 +506 2 +507 2 +508 1 +509 2 +510 2 +511 1 +512 2 +513 2 +514 1 +515 2 +516 2 +517 1 +518 2 +519 2 +520 1 +521 2 +522 2 +523 1 +524 2 +525 2 +526 1 +527 2 +528 2 +529 1 +530 2 +531 2 +532 1 +533 2 +534 2 +535 1 +536 2 +537 2 +538 1 +539 2 +540 2 +541 1 +542 2 +543 2 +544 1 +545 2 +546 2 +547 1 +548 2 +549 2 +550 1 +551 2 +552 2 +553 1 +554 2 +555 2 +556 1 +557 2 +558 2 +559 1 +560 2 +561 2 +562 1 +563 2 +564 2 +565 1 +566 2 +567 2 +568 1 +569 2 +570 2 +571 1 +572 2 +573 2 +574 1 +575 2 +576 2 +577 1 +578 2 +579 2 +580 1 +581 2 +582 2 +583 1 +584 2 +585 2 +586 1 +587 2 +588 2 +589 1 +590 2 +591 2 +592 1 +593 2 +594 2 +595 1 +596 2 +597 2 +598 1 +599 2 +600 2 +601 1 +602 2 +603 2 +604 1 +605 2 +606 2 +607 1 +608 2 +609 2 +610 1 +611 2 +612 2 +613 1 +614 2 +615 2 +616 1 +617 2 +618 2 +619 1 +620 2 +621 2 +622 1 +623 2 +624 2 +625 1 +626 2 +627 2 +628 1 +629 2 +630 2 +631 1 +632 2 +633 2 +634 1 +635 2 +636 2 +637 1 +638 2 +639 2 +640 1 +641 2 +642 2 +643 1 +644 2 +645 2 +646 1 +647 2 +648 2 diff --git a/examples/amoeba/data.water_dimer.amoeba b/examples/amoeba/data.water_dimer.amoeba index 591d081268..50b2b7dde7 100644 --- a/examples/amoeba/data.water_dimer.amoeba +++ b/examples/amoeba/data.water_dimer.amoeba @@ -1,4 +1,4 @@ -LAMMPS data file created from Tinker water_dimer.xyz and water03.prm files +LAMMPS data file created from Tinker ../TINKER_TESTS/water_dimer/water_dimer.xyz and ../TINKER_TESTS/water_dimer/amoeba.prm files 6 atoms 4 bonds @@ -38,17 +38,17 @@ Angles Bond Coeffs -1 556.85 0.9572 +1 0.9572 556.85 -1419.9675 2112.20165625 Angle Coeffs -1 48.70 108.50 +1 0 108.5 48.7 -39.064262472 8.95286947775 -6.41202044508 11.5462823034 Tinker Types -1 1 1 -2 2 1 -3 2 1 -4 1 2 -5 2 2 -6 2 2 +1 1 +2 2 +3 2 +4 1 +5 2 +6 2 diff --git a/examples/amoeba/data.water_dimer.hippo b/examples/amoeba/data.water_dimer.hippo index 875c90bc55..40709ab1be 100644 --- a/examples/amoeba/data.water_dimer.hippo +++ b/examples/amoeba/data.water_dimer.hippo @@ -1,4 +1,4 @@ -LAMMPS data file created from Tinker water_dimer.xyz and water19.prm files +LAMMPS data file created from Tinker water_dimer.xyz and hippo.prm files 6 atoms 4 bonds @@ -38,17 +38,17 @@ Angles Bond Coeffs -1 556.85 0.9572 +1 0.9572 556.85 -1419.9675 2112.20165625 Angle Coeffs -1 48.70 107.70 +1 0 107.7 48.7 -39.064262472 8.95286947775 -6.41202044508 11.5462823034 Tinker Types -1 1 1 -2 2 1 -3 2 1 -4 1 2 -5 2 2 -6 2 2 +1 1 +2 2 +3 2 +4 1 +5 2 +6 2 diff --git a/examples/amoeba/data.water_hexamer.amoeba b/examples/amoeba/data.water_hexamer.amoeba index c20f81e3ed..ed76cc5186 100644 --- a/examples/amoeba/data.water_hexamer.amoeba +++ b/examples/amoeba/data.water_hexamer.amoeba @@ -1,4 +1,4 @@ -LAMMPS data file created from Tinker water_hexamer.xyz and water03.prm files +LAMMPS data file created from Tinker water_hexamer.xyz and amoeba.prm files 18 atoms 12 bonds @@ -62,29 +62,29 @@ Angles Bond Coeffs -1 556.85 0.9572 +1 0.9572 556.85 -1419.9675 2112.20165625 Angle Coeffs -1 48.70 108.50 +1 0 108.5 48.7 -39.064262472 8.95286947775 -6.41202044508 11.5462823034 Tinker Types -1 1 1 -2 2 1 -3 2 1 -4 1 2 -5 2 2 -6 2 2 -7 1 3 -8 2 3 -9 2 3 -10 1 4 -11 2 4 -12 2 4 -13 1 5 -14 2 5 -15 2 5 -16 1 6 -17 2 6 -18 2 6 +1 1 +2 2 +3 2 +4 1 +5 2 +6 2 +7 1 +8 2 +9 2 +10 1 +11 2 +12 2 +13 1 +14 2 +15 2 +16 1 +17 2 +18 2 diff --git a/examples/amoeba/data.water_hexamer.hippo b/examples/amoeba/data.water_hexamer.hippo index d83df2122a..69afeefed5 100644 --- a/examples/amoeba/data.water_hexamer.hippo +++ b/examples/amoeba/data.water_hexamer.hippo @@ -1,4 +1,4 @@ -LAMMPS data file created from Tinker water_hexamer.xyz and water19.prm files +LAMMPS data file created from Tinker water_hexamer.xyz and hippo.prm files 18 atoms 12 bonds @@ -62,29 +62,29 @@ Angles Bond Coeffs -1 556.85 0.9572 +1 0.9572 556.85 -1419.9675 2112.20165625 Angle Coeffs -1 48.70 107.70 +1 0 107.7 48.7 -39.064262472 8.95286947775 -6.41202044508 11.5462823034 Tinker Types -1 1 1 -2 2 1 -3 2 1 -4 1 2 -5 2 2 -6 2 2 -7 1 3 -8 2 3 -9 2 3 -10 1 4 -11 2 4 -12 2 4 -13 1 5 -14 2 5 -15 2 5 -16 1 6 -17 2 6 -18 2 6 +1 1 +2 2 +3 2 +4 1 +5 2 +6 2 +7 1 +8 2 +9 2 +10 1 +11 2 +12 2 +13 1 +14 2 +15 2 +16 1 +17 2 +18 2 diff --git a/examples/amoeba/in.ubiquitin b/examples/amoeba/in.ubiquitin index e6f9893e41..60c1b79054 100644 --- a/examples/amoeba/in.ubiquitin +++ b/examples/amoeba/in.ubiquitin @@ -30,6 +30,15 @@ compute virial all pressure NULL virial thermo_style custom step temp epair ebond eangle edihed eimp & emol etotal press c_virial[*] -# 0-step run +# DEBUG: setup force components this way so can dump them + +fix fhal all store/state 0 fx fy fz +fix frepulse all store/state 0 fx fy fz +fix fdisp all store/state 0 fx fy fz +fix fpolar all store/state 0 fx fy fz +fix fmpole all store/state 0 fx fy fz +fix fqxfer all store/state 0 fx fy fz + +# zero step run run 0 diff --git a/examples/amoeba/in.water_box b/examples/amoeba/in.water_box.amoeba similarity index 68% rename from examples/amoeba/in.water_box rename to examples/amoeba/in.water_box.amoeba index d4dd40edcd..63ada708f7 100644 --- a/examples/amoeba/in.water_box +++ b/examples/amoeba/in.water_box.amoeba @@ -18,16 +18,12 @@ fix extra2 all property/atom i_polaxe # read data file read_data data.water_box.amoeba fix amtype NULL "Tinker Types" -#read_data data.water_box.hippo fix amtype NULL "Tinker Types" # force field pair_style amoeba pair_coeff * * amoeba_water.prm amoeba_water.key -#pair_style hippo -#pair_coeff * * hippo_water.prm hippo_water.key - # thermo output compute virial all pressure NULL virial @@ -35,6 +31,15 @@ compute virial all pressure NULL virial thermo_style custom step temp epair ebond eangle edihed eimp & emol etotal press c_virial[*] -# 0-step run +# DEBUG: setup force components this way so can dump them + +fix fhal all store/state 0 fx fy fz +fix frepulse all store/state 0 fx fy fz +fix fdisp all store/state 0 fx fy fz +fix fpolar all store/state 0 fx fy fz +fix fmpole all store/state 0 fx fy fz +fix fqxfer all store/state 0 fx fy fz + +# zero step run run 0 diff --git a/examples/amoeba/in.water_box.hippo b/examples/amoeba/in.water_box.hippo new file mode 100644 index 0000000000..6547a135b6 --- /dev/null +++ b/examples/amoeba/in.water_box.hippo @@ -0,0 +1,45 @@ +# water box with AMOEBA or HIPPO + +units real +boundary p p p + +atom_style amoeba +bond_style class2 +angle_style amoeba +dihedral_style none + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom & + i_amgroup i_ired i_xaxis i_yaxis i_zaxis d_pval ghost yes +fix extra2 all property/atom i_polaxe + +# read data file + +read_data data.water_box.hippo fix amtype NULL "Tinker Types" + +# force field + +pair_style hippo +pair_coeff * * hippo_water.prm hippo_water.key + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp & + emol etotal press c_virial[*] + +# DEBUG: setup force components this way so can dump them + +fix fhal all store/state 0 fx fy fz +fix frepulse all store/state 0 fx fy fz +fix fdisp all store/state 0 fx fy fz +fix fpolar all store/state 0 fx fy fz +fix fmpole all store/state 0 fx fy fz +fix fqxfer all store/state 0 fx fy fz + +# zero step run + +run 0 diff --git a/examples/amoeba/in.water_dimer b/examples/amoeba/in.water_dimer.amoeba similarity index 68% rename from examples/amoeba/in.water_dimer rename to examples/amoeba/in.water_dimer.amoeba index 4a8d07743f..af22009269 100644 --- a/examples/amoeba/in.water_dimer +++ b/examples/amoeba/in.water_dimer.amoeba @@ -18,16 +18,12 @@ fix extra2 all property/atom i_polaxe # read data file read_data data.water_dimer.amoeba fix amtype NULL "Tinker Types" -#read_data data.water_dimer.hippo fix amtype NULL "Tinker Types" # force field pair_style amoeba pair_coeff * * amoeba_water.prm amoeba_water.key -#pair_style hippo -#pair_coeff * * hippo_water.prm hippo_water.key - # thermo output compute virial all pressure NULL virial @@ -35,6 +31,15 @@ compute virial all pressure NULL virial thermo_style custom step temp epair ebond eangle edihed eimp & emol etotal press c_virial[*] -# 0-step run +# DEBUG: setup force components this way so can dump them + +fix fhal all store/state 0 fx fy fz +fix frepulse all store/state 0 fx fy fz +fix fdisp all store/state 0 fx fy fz +fix fpolar all store/state 0 fx fy fz +fix fmpole all store/state 0 fx fy fz +fix fqxfer all store/state 0 fx fy fz + +# zero step run run 0 diff --git a/examples/amoeba/in.water_dimer.hippo b/examples/amoeba/in.water_dimer.hippo new file mode 100644 index 0000000000..b19cbc0f26 --- /dev/null +++ b/examples/amoeba/in.water_dimer.hippo @@ -0,0 +1,45 @@ +# water dimer with AMOEBA or HIPPO + +units real +boundary s s s + +atom_style amoeba +bond_style class2 +angle_style amoeba +dihedral_style none + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom & + i_amgroup i_ired i_xaxis i_yaxis i_zaxis d_pval ghost yes +fix extra2 all property/atom i_polaxe + +# read data file + +read_data data.water_dimer.hippo fix amtype NULL "Tinker Types" + +# force field + +pair_style hippo +pair_coeff * * hippo_water.prm hippo_water.key + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp & + emol etotal press c_virial[*] + +# DEBUG: setup force components this way so can dump them + +fix fhal all store/state 0 fx fy fz +fix frepulse all store/state 0 fx fy fz +fix fdisp all store/state 0 fx fy fz +fix fpolar all store/state 0 fx fy fz +fix fmpole all store/state 0 fx fy fz +fix fqxfer all store/state 0 fx fy fz + +# zero step run + +run 0 diff --git a/examples/amoeba/in.water_hexamer b/examples/amoeba/in.water_hexamer.amoeba similarity index 69% rename from examples/amoeba/in.water_hexamer rename to examples/amoeba/in.water_hexamer.amoeba index 59c8d4ce12..cafab56053 100644 --- a/examples/amoeba/in.water_hexamer +++ b/examples/amoeba/in.water_hexamer.amoeba @@ -18,16 +18,12 @@ fix extra2 all property/atom i_polaxe # read data file read_data data.water_hexamer.amoeba fix amtype NULL "Tinker Types" -#read_data data.water_hexamer.hippo fix amtype NULL "Tinker Types" # force field pair_style amoeba pair_coeff * * amoeba_water.prm amoeba_water.key -#pair_style hippo -#pair_coeff * * hippo_water.prm hippo_water.key - # thermo output compute virial all pressure NULL virial @@ -35,6 +31,15 @@ compute virial all pressure NULL virial thermo_style custom step temp epair ebond eangle edihed eimp & emol etotal press c_virial[*] -# 0-step run +# DEBUG: setup force components this way so can dump them + +fix fhal all store/state 0 fx fy fz +fix frepulse all store/state 0 fx fy fz +fix fdisp all store/state 0 fx fy fz +fix fpolar all store/state 0 fx fy fz +fix fmpole all store/state 0 fx fy fz +fix fqxfer all store/state 0 fx fy fz + +# zero step run run 0 diff --git a/examples/amoeba/in.water_hexamer.hippo b/examples/amoeba/in.water_hexamer.hippo new file mode 100644 index 0000000000..27cdb6e634 --- /dev/null +++ b/examples/amoeba/in.water_hexamer.hippo @@ -0,0 +1,45 @@ +# water hexamer with AMOEBA or HIPPO + +units real +boundary s s s + +atom_style amoeba +bond_style class2 +angle_style amoeba +dihedral_style none + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom & + i_amgroup i_ired i_xaxis i_yaxis i_zaxis d_pval ghost yes +fix extra2 all property/atom i_polaxe + +# read data file + +read_data data.water_hexamer.hippo fix amtype NULL "Tinker Types" + +# force field + +pair_style hippo +pair_coeff * * hippo_water.prm hippo_water.key + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp & + emol etotal press c_virial[*] + +# DEBUG: setup force components this way so can dump them + +fix fhal all store/state 0 fx fy fz +fix frepulse all store/state 0 fx fy fz +fix fdisp all store/state 0 fx fy fz +fix fpolar all store/state 0 fx fy fz +fix fmpole all store/state 0 fx fy fz +fix fqxfer all store/state 0 fx fy fz + +# zero step run + +run 0 diff --git a/src/fix_property_atom.cpp b/src/fix_property_atom.cpp index e57046f638..6aa8f1f0de 100644 --- a/src/fix_property_atom.cpp +++ b/src/fix_property_atom.cpp @@ -223,7 +223,7 @@ FixPropertyAtom::~FixPropertyAtom() } } - delete [] style; + delete [] styles; delete [] cols; delete [] index; delete [] astyle; From c0b31c4384ed9747e65bd7ace5aeca767df5d71d Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Thu, 26 Aug 2021 15:10:10 -0600 Subject: [PATCH 037/585] remove unneeded file --- examples/amoeba/data.water_box | 1980 -------------------------------- 1 file changed, 1980 deletions(-) delete mode 100644 examples/amoeba/data.water_box diff --git a/examples/amoeba/data.water_box b/examples/amoeba/data.water_box deleted file mode 100644 index 9881b4bce2..0000000000 --- a/examples/amoeba/data.water_box +++ /dev/null @@ -1,1980 +0,0 @@ -LAMMPS data file created from Tinker watersmall.xyz and amoeba_watersmall.prm files - -648 atoms -432 bonds -216 angles -2 atom types -1 bond types -1 angle types -0 18.643 xlo xhi -0 18.643 ylo yhi -0 18.643 zlo zhi - -Masses - -1 15.995 -2 1.008 - -Atoms - -1 1 1 0 8.679662 7.087692 -0.696862 -2 1 2 0 7.809455 6.755792 -0.382259 -3 1 2 0 8.722232 6.814243 -1.617561 -4 2 1 0 -0.117313 8.244447 6.837616 -5 2 2 0 0.216892 7.895445 6.050027 -6 2 2 0 0.444268 7.826013 7.530196 -7 3 1 0 8.379057 -0.092611 6.814631 -8 3 2 0 9.340423 0.098069 6.734062 -9 3 2 0 7.939619 0.573676 6.269838 -10 4 1 0 6.589952 1.844323 -6.923167 -11 4 2 0 5.885429 2.402305 -6.717934 -12 4 2 0 6.181533 1.062747 -7.273678 -13 5 1 0 7.146600 5.753582 2.331517 -14 5 2 0 6.368123 6.126035 2.862678 -15 5 2 0 7.025018 6.294645 1.518196 -16 6 1 0 -2.426581 -8.504195 -2.504834 -17 6 2 0 -1.692063 -8.368252 -3.058292 -18 6 2 0 -2.793207 -7.602469 -2.403097 -19 7 1 0 -8.038375 -3.605589 2.303691 -20 7 2 0 -8.113753 -4.248127 3.018494 -21 7 2 0 -7.619392 -2.863004 2.709622 -22 8 1 0 -1.480631 8.244085 -8.272215 -23 8 2 0 -2.090204 8.687978 -7.676996 -24 8 2 0 -0.700878 8.823325 -8.322213 -25 9 1 0 -3.741962 -2.777830 -2.326319 -26 9 2 0 -4.620456 -2.444778 -2.390519 -27 9 2 0 -3.728921 -3.160952 -1.433101 -28 10 1 0 -6.467812 -5.265942 0.408263 -29 10 2 0 -6.585076 -4.796537 -0.413008 -30 10 2 0 -7.021252 -4.752640 1.007958 -31 11 1 0 9.273577 5.342431 4.055460 -32 11 2 0 8.645939 5.466500 4.837640 -33 11 2 0 8.741774 5.686149 3.302820 -34 12 1 0 1.830160 4.276731 -6.993499 -35 12 2 0 1.703275 5.223773 -6.703852 -36 12 2 0 2.408113 3.853447 -6.383339 -37 13 1 0 1.964382 6.832988 8.373101 -38 13 2 0 2.496135 7.215781 9.056298 -39 13 2 0 1.811283 5.905846 8.573539 -40 14 1 0 5.405568 4.388994 7.932737 -41 14 2 0 5.537380 3.438955 7.781311 -42 14 2 0 4.755156 4.734908 7.290617 -43 15 1 0 3.229998 2.928417 -1.090650 -44 15 2 0 3.931090 3.198265 -1.702769 -45 15 2 0 3.004438 3.708969 -0.493266 -46 16 1 0 7.462400 5.262829 6.131170 -47 16 2 0 8.025650 5.588493 6.881770 -48 16 2 0 6.935076 4.455766 6.325405 -49 17 1 0 -8.864042 7.023845 -6.659632 -50 17 2 0 -8.370939 6.372557 -7.141895 -51 17 2 0 -9.489800 7.315873 -7.293125 -52 18 1 0 -4.526299 3.549989 8.030031 -53 18 2 0 -5.169770 4.224127 7.731323 -54 18 2 0 -4.262096 3.801892 8.884875 -55 19 1 0 4.823286 -1.386218 4.038464 -56 19 2 0 5.493155 -0.669965 4.013081 -57 19 2 0 4.187463 -1.101832 3.338433 -58 20 1 0 -2.151150 -2.017060 -8.593685 -59 20 2 0 -2.475709 -2.320356 -7.783564 -60 20 2 0 -2.650484 -2.434614 -9.307384 -61 21 1 0 1.944893 4.933226 0.497910 -62 21 2 0 2.553221 5.263352 1.205303 -63 21 2 0 2.082534 5.590999 -0.202171 -64 22 1 0 -6.827006 -5.285917 -2.371899 -65 22 2 0 -7.405873 -6.022738 -2.075913 -66 22 2 0 -6.398443 -5.453726 -3.235054 -67 23 1 0 -8.538047 -7.577917 -1.688532 -68 23 2 0 -8.075591 -8.448260 -1.513455 -69 23 2 0 -9.389507 -7.836271 -2.051835 -70 24 1 0 -6.916556 -1.100882 -5.168782 -71 24 2 0 -6.365888 -1.659366 -5.746210 -72 24 2 0 -6.538885 -0.249374 -5.325993 -73 25 1 0 6.330290 -9.323893 -6.416630 -74 25 2 0 7.026026 -9.680578 -7.007727 -75 25 2 0 6.812488 -8.683594 -5.925799 -76 26 1 0 -2.424345 -5.918126 2.701855 -77 26 2 0 -1.613829 -5.486394 2.503024 -78 26 2 0 -3.144797 -5.307275 2.618121 -79 27 1 0 0.637202 -6.080457 5.849135 -80 27 2 0 0.892312 -6.092342 4.907709 -81 27 2 0 -0.339074 -5.838972 5.853292 -82 28 1 0 5.199216 -2.264918 -0.138343 -83 28 2 0 5.802838 -2.788698 -0.697536 -84 28 2 0 5.670340 -1.679393 0.462296 -85 29 1 0 0.510145 7.629450 4.054500 -86 29 2 0 -0.071135 8.146563 3.452959 -87 29 2 0 1.464962 7.740819 3.669172 -88 30 1 0 3.146724 8.895843 6.526257 -89 30 2 0 3.506091 8.599906 7.352942 -90 30 2 0 2.145729 8.929622 6.682029 -91 31 1 0 7.308541 -8.339335 -2.471342 -92 31 2 0 6.562127 -8.180601 -3.062803 -93 31 2 0 6.993025 -8.364954 -1.531235 -94 32 1 0 -7.530792 1.069683 4.989387 -95 32 2 0 -7.565406 1.971422 4.648636 -96 32 2 0 -7.938250 0.433547 4.370266 -97 33 1 0 4.452035 2.700609 -5.437815 -98 33 2 0 4.603326 3.058652 -4.551590 -99 33 2 0 4.386453 1.737004 -5.180419 -100 34 1 0 8.427922 -8.619286 1.784691 -101 34 2 0 8.340498 -8.005342 2.536225 -102 34 2 0 8.496720 -9.530562 2.174667 -103 35 1 0 -8.109456 1.753830 -3.096997 -104 35 2 0 -7.245287 1.827177 -2.721417 -105 35 2 0 -8.082178 1.783171 -4.059329 -106 36 1 0 2.776933 -5.701955 7.748213 -107 36 2 0 3.287974 -5.069688 7.233816 -108 36 2 0 1.987041 -5.817355 7.200131 -109 37 1 0 3.635171 -6.953519 5.339628 -110 37 2 0 3.353851 -7.592789 6.031367 -111 37 2 0 2.875801 -6.787975 4.740576 -112 38 1 0 6.888027 -4.169023 -1.800190 -113 38 2 0 7.559735 -4.813701 -2.004669 -114 38 2 0 6.603805 -3.759237 -2.626496 -115 39 1 0 -4.470837 -4.105640 3.415362 -116 39 2 0 -4.991607 -3.358538 3.140956 -117 39 2 0 -4.791764 -4.392214 4.254387 -118 40 1 0 8.282263 -0.462068 -2.560579 -119 40 2 0 8.776769 -1.293641 -2.335945 -120 40 2 0 8.760297 0.384816 -2.651128 -121 41 1 0 4.737236 1.616430 4.901115 -122 41 2 0 3.969692 2.168368 5.152631 -123 41 2 0 5.184651 2.148403 4.154746 -124 42 1 0 -3.497332 -5.781436 -2.202713 -125 42 2 0 -4.038857 -5.773824 -1.381680 -126 42 2 0 -4.152970 -6.012265 -2.829379 -127 43 1 0 -2.863989 -0.259334 -1.857006 -128 43 2 0 -2.132201 -0.027953 -1.174211 -129 43 2 0 -2.873625 -1.224425 -1.874253 -130 44 1 0 1.138300 1.133100 -2.085899 -131 44 2 0 1.965506 1.503520 -1.725316 -132 44 2 0 0.420521 1.534440 -1.551356 -133 45 1 0 -0.561328 4.590705 -2.780017 -134 45 2 0 -0.061173 3.919356 -3.294128 -135 45 2 0 -0.082763 4.733898 -1.955602 -136 46 1 0 -6.423002 -1.705204 -2.528225 -137 46 2 0 -7.233989 -1.949552 -1.975418 -138 46 2 0 -6.678416 -1.321413 -3.351278 -139 47 1 0 -2.772100 2.552210 -0.672282 -140 47 2 0 -2.907489 3.483552 -0.385605 -141 47 2 0 -2.977127 2.592348 -1.635820 -142 48 1 0 6.708678 -4.852016 -8.379280 -143 48 2 0 6.593474 -5.094964 -7.447187 -144 48 2 0 6.582524 -5.591596 -8.966502 -145 49 1 0 -8.497001 -0.440284 2.803721 -146 49 2 0 -8.422350 0.331961 2.183451 -147 49 2 0 -9.377295 -0.756160 2.677026 -148 50 1 0 2.975383 -0.894970 6.060783 -149 50 2 0 2.093991 -0.995700 5.670129 -150 50 2 0 3.458832 -0.759248 5.263958 -151 51 1 0 -6.085023 -1.629620 7.970284 -152 51 2 0 -6.685848 -2.391830 7.820849 -153 51 2 0 -6.177296 -1.190584 8.835912 -154 52 1 0 -3.763523 -3.356777 8.285436 -155 52 2 0 -4.660650 -3.029414 8.406662 -156 52 2 0 -3.411834 -3.178947 7.431180 -157 53 1 0 -1.100120 -0.320162 0.375372 -158 53 2 0 -0.527013 -1.012183 0.128652 -159 53 2 0 -0.673226 0.288559 0.934677 -160 54 1 0 0.910209 -8.271802 1.411429 -161 54 2 0 0.158544 -8.759532 1.870895 -162 54 2 0 0.565924 -7.546113 0.944383 -163 55 1 0 1.554065 -6.468033 3.310872 -164 55 2 0 1.362455 -7.162802 2.722340 -165 55 2 0 1.616233 -5.622409 2.872854 -166 56 1 0 0.543127 -1.388652 4.886094 -167 56 2 0 0.110320 -0.665826 5.311239 -168 56 2 0 0.420366 -2.216367 5.267301 -169 57 1 0 1.100526 1.019490 -9.255318 -170 57 2 0 1.460815 0.575286 -8.484128 -171 57 2 0 0.265613 0.594128 -9.297750 -172 58 1 0 -1.842348 2.327827 -5.355326 -173 58 2 0 -1.572941 2.573139 -6.288125 -174 58 2 0 -2.216679 1.439934 -5.361006 -175 59 1 0 2.452307 -2.814686 -6.448759 -176 59 2 0 2.862295 -3.091668 -5.589336 -177 59 2 0 2.913920 -3.262923 -7.181510 -178 60 1 0 -2.207998 -3.112007 5.945795 -179 60 2 0 -1.262203 -3.125339 6.205467 -180 60 2 0 -2.228269 -2.421858 5.220629 -181 61 1 0 5.845471 5.020556 -6.836491 -182 61 2 0 5.557986 5.913737 -6.753889 -183 61 2 0 5.089998 4.459153 -6.661079 -184 62 1 0 -3.421643 4.865553 0.731755 -185 62 2 0 -3.965419 4.458452 1.478214 -186 62 2 0 -3.973445 4.958338 -0.044430 -187 63 1 0 -2.302950 -2.349717 2.112168 -188 63 2 0 -2.576438 -1.873492 2.873191 -189 63 2 0 -1.882868 -1.715106 1.503782 -190 64 1 0 0.305885 4.878766 3.791182 -191 64 2 0 0.299338 5.855407 4.097578 -192 64 2 0 1.169911 4.563497 4.030616 -193 65 1 0 2.925008 -3.664845 -3.607450 -194 65 2 0 3.015896 -3.916618 -2.644267 -195 65 2 0 2.353923 -2.889459 -3.518284 -196 66 1 0 1.111505 -4.070255 -9.085693 -197 66 2 0 2.084905 -4.227348 -9.180249 -198 66 2 0 0.897072 -4.902218 -8.740523 -199 67 1 0 -4.992929 -1.974219 -7.099668 -200 67 2 0 -5.173269 -1.186309 -7.673625 -201 67 2 0 -5.070893 -2.753273 -7.658821 -202 68 1 0 4.730983 1.478420 0.720986 -203 68 2 0 4.271686 1.988265 0.034225 -204 68 2 0 4.117413 0.788607 1.061818 -205 69 1 0 1.421583 -0.176666 -6.729105 -206 69 2 0 1.217660 0.394331 -5.978213 -207 69 2 0 1.948444 -0.877988 -6.400659 -208 70 1 0 -7.093223 -8.541193 4.116187 -209 70 2 0 -7.074252 -8.047477 3.242159 -210 70 2 0 -6.153142 -8.537148 4.455550 -211 71 1 0 8.382540 -6.460958 3.765735 -212 71 2 0 9.258625 -6.141972 4.060763 -213 71 2 0 7.637364 -6.217910 4.407852 -214 72 1 0 -4.320241 4.037137 3.297092 -215 72 2 0 -3.750151 4.141786 4.105470 -216 72 2 0 -5.172925 4.455578 3.488906 -217 73 1 0 5.581877 1.781994 7.505132 -218 73 2 0 5.017196 1.139584 8.120950 -219 73 2 0 5.330781 1.591217 6.595286 -220 74 1 0 -0.734443 1.125031 4.884666 -221 74 2 0 -0.239224 1.540322 4.142070 -222 74 2 0 -0.961628 1.783437 5.554548 -223 75 1 0 6.831005 -9.249970 4.497165 -224 75 2 0 6.836746 -9.068011 5.427146 -225 75 2 0 7.668067 -9.652510 4.249957 -226 76 1 0 2.714055 -3.677581 1.962003 -227 76 2 0 3.333432 -3.851775 2.663540 -228 76 2 0 3.095021 -3.978526 1.102566 -229 77 1 0 -1.364034 -5.762724 -5.514747 -230 77 2 0 -2.238584 -5.409106 -5.314718 -231 77 2 0 -0.948185 -4.908428 -5.559580 -232 78 1 0 -3.623435 -8.061229 1.383141 -233 78 2 0 -3.132847 -7.446722 1.857906 -234 78 2 0 -4.307943 -7.546630 0.933298 -235 79 1 0 5.717894 6.958376 4.528556 -236 79 2 0 5.852657 7.879846 4.341790 -237 79 2 0 6.443636 6.708413 5.135144 -238 80 1 0 8.121415 8.262619 -8.483986 -239 80 2 0 8.585190 8.939651 -8.974230 -240 80 2 0 7.560207 7.748539 -9.044644 -241 81 1 0 -5.111889 -0.352865 5.807903 -242 81 2 0 -5.940048 0.102298 5.569630 -243 81 2 0 -5.349104 -1.014090 6.507582 -244 82 1 0 0.327324 2.563438 0.113251 -245 82 2 0 -0.633994 2.522136 -0.069385 -246 82 2 0 0.724331 3.482989 0.160564 -247 83 1 0 -6.003367 -7.683112 -8.874252 -248 83 2 0 -6.987751 -7.912403 -8.892689 -249 83 2 0 -5.699015 -8.504722 -8.558813 -250 84 1 0 0.789377 -6.357883 -7.563043 -251 84 2 0 -0.151101 -6.341313 -7.440906 -252 84 2 0 1.090881 -5.879281 -6.770796 -253 85 1 0 5.045666 7.219298 -5.151826 -254 85 2 0 5.598994 7.846492 -5.618276 -255 85 2 0 5.480466 6.978976 -4.337211 -256 86 1 0 1.286092 6.990271 -6.806004 -257 86 2 0 0.481329 7.140371 -7.345224 -258 86 2 0 1.716012 7.791024 -6.762706 -259 87 1 0 -3.198783 -9.175883 -6.334156 -260 87 2 0 -3.032721 -8.198157 -6.198635 -261 87 2 0 -3.084774 -9.539992 -5.434969 -262 88 1 0 -2.002554 -5.668583 5.440781 -263 88 2 0 -2.347493 -4.756386 5.542471 -264 88 2 0 -2.133027 -6.049986 4.540349 -265 89 1 0 6.174952 -8.574733 0.210584 -266 89 2 0 5.358389 -8.191902 0.557392 -267 89 2 0 6.760918 -8.561710 0.943985 -268 90 1 0 -6.278610 6.057339 4.042358 -269 90 2 0 -6.169211 6.708022 3.383078 -270 90 2 0 -7.221766 5.771239 4.032205 -271 91 1 0 0.124733 -5.816398 0.203961 -272 91 2 0 0.029974 -5.049468 0.786871 -273 91 2 0 -0.458026 -5.646677 -0.555312 -274 92 1 0 3.839311 -0.064469 8.619720 -275 92 2 0 3.586253 -0.282978 7.705313 -276 92 2 0 3.079936 0.282626 9.065559 -277 93 1 0 7.375986 -1.368885 4.452411 -278 93 2 0 8.024931 -0.682735 4.768078 -279 93 2 0 7.477247 -1.279372 3.493009 -280 94 1 0 9.209092 -1.611532 -6.423337 -281 94 2 0 9.487648 -2.470973 -6.800897 -282 94 2 0 9.998917 -1.354277 -5.866779 -283 95 1 0 -5.314625 -5.613762 7.941745 -284 95 2 0 -5.589748 -6.389969 8.478078 -285 95 2 0 -4.444519 -5.357513 8.149460 -286 96 1 0 -3.655884 2.941259 -3.295211 -287 96 2 0 -4.418712 2.528163 -3.712668 -288 96 2 0 -2.937568 3.025005 -3.971189 -289 97 1 0 -8.786626 -3.149090 -1.640379 -290 97 2 0 -8.441651 -4.011755 -1.901885 -291 97 2 0 -9.285717 -3.276173 -0.834535 -292 98 1 0 -7.358188 8.239942 -2.093781 -293 98 2 0 -7.811518 7.751233 -2.768278 -294 98 2 0 -6.892430 7.625331 -1.541437 -295 99 1 0 3.770974 -0.453172 -1.931225 -296 99 2 0 4.245757 -0.966218 -1.286114 -297 99 2 0 3.797803 0.441972 -1.542180 -298 100 1 0 2.205813 4.098894 8.958738 -299 100 2 0 3.001973 3.555440 8.746430 -300 100 2 0 2.103639 4.243668 9.940011 -301 101 1 0 -8.723398 -8.284874 -8.890692 -302 101 2 0 -9.298972 -7.537539 -9.239127 -303 101 2 0 -8.772683 -8.361037 -7.925940 -304 102 1 0 -8.908952 0.807167 -7.785764 -305 102 2 0 -9.061230 -0.061912 -7.422589 -306 102 2 0 -9.534219 1.030144 -8.475490 -307 103 1 0 9.182207 -3.418263 -8.430667 -308 103 2 0 9.046738 -2.558299 -8.879898 -309 103 2 0 8.390804 -3.958734 -8.701949 -310 104 1 0 1.003162 9.279867 -8.313986 -311 104 2 0 1.167271 10.190392 -8.070619 -312 104 2 0 1.849962 8.761188 -8.493178 -313 105 1 0 -1.842572 4.893383 8.198130 -314 105 2 0 -2.468210 5.316242 8.833179 -315 105 2 0 -1.155294 4.389410 8.716281 -316 106 1 0 -4.005055 -3.953707 0.402347 -317 106 2 0 -3.682148 -3.305443 1.058769 -318 106 2 0 -4.738199 -4.452434 0.841144 -319 107 1 0 3.511815 -7.590537 -9.004707 -320 107 2 0 3.415066 -7.281286 -8.094635 -321 107 2 0 3.251550 -6.835442 -9.579171 -322 108 1 0 -7.614136 -7.773463 1.262079 -323 108 2 0 -7.489497 -6.927033 0.753779 -324 108 2 0 -8.528840 -8.050689 1.164710 -325 109 1 0 -5.419143 7.061880 -5.745275 -326 109 2 0 -4.504905 6.840455 -5.750772 -327 109 2 0 -5.895918 6.221393 -5.676189 -328 110 1 0 -9.017162 1.888781 0.937813 -329 110 2 0 -9.868157 2.115056 0.623903 -330 110 2 0 -8.466599 1.708818 0.191067 -331 111 1 0 -8.037596 -5.106016 4.750802 -332 111 2 0 -7.322228 -5.707104 5.043673 -333 111 2 0 -8.230169 -4.481051 5.475067 -334 112 1 0 -4.390546 1.691502 -7.756245 -335 112 2 0 -3.558844 1.264966 -7.996466 -336 112 2 0 -4.136121 2.629917 -7.760619 -337 113 1 0 -3.975194 -6.218233 -6.927330 -338 113 2 0 -3.085645 -6.066352 -7.325296 -339 113 2 0 -4.640815 -6.676349 -7.524295 -340 114 1 0 8.240648 5.082183 -8.857912 -341 114 2 0 7.453645 5.101728 -8.259448 -342 114 2 0 8.368223 4.228825 -9.227974 -343 115 1 0 1.598931 -1.829796 -0.316752 -344 115 2 0 1.992252 -1.475465 -1.149815 -345 115 2 0 1.726926 -2.749881 -0.397199 -346 116 1 0 1.433819 -1.386702 -3.304673 -347 116 2 0 1.323094 -0.486757 -3.067110 -348 116 2 0 0.623143 -1.802016 -3.264828 -349 117 1 0 3.735991 5.554990 6.219603 -350 117 2 0 3.320916 6.265941 6.761937 -351 117 2 0 4.195666 6.053207 5.526652 -352 118 1 0 -6.285976 -9.228132 -4.460410 -353 118 2 0 -5.683885 -10.005163 -4.740870 -354 118 2 0 -6.707036 -9.488426 -3.608438 -355 119 1 0 4.036200 -3.378299 6.905724 -356 119 2 0 3.457441 -2.618106 6.794504 -357 119 2 0 4.929409 -2.991177 6.666963 -358 120 1 0 0.606517 8.561279 -3.782406 -359 120 2 0 0.498099 9.526035 -3.699299 -360 120 2 0 1.288545 8.500162 -4.475972 -361 121 1 0 -5.666717 8.368298 -8.299623 -362 121 2 0 -4.926661 7.904359 -8.744783 -363 121 2 0 -5.742748 8.095703 -7.389592 -364 122 1 0 -3.344692 7.636718 3.475830 -365 122 2 0 -4.140634 7.105012 3.296472 -366 122 2 0 -3.350797 7.470949 4.433350 -367 123 1 0 -1.322186 6.638182 0.028906 -368 123 2 0 -1.895088 6.054034 0.554933 -369 123 2 0 -1.928852 7.271511 -0.442137 -370 124 1 0 8.793551 6.925450 7.841717 -371 124 2 0 9.639675 7.325848 7.850680 -372 124 2 0 8.776882 6.398711 8.674036 -373 125 1 0 -6.322101 0.607808 1.174099 -374 125 2 0 -5.647986 1.150825 1.588348 -375 125 2 0 -5.852992 -0.060471 0.660730 -376 126 1 0 5.685139 -3.546046 -4.128549 -377 126 2 0 4.727966 -3.473549 -4.165755 -378 126 2 0 6.024761 -2.749532 -4.610993 -379 127 1 0 3.821999 6.538527 1.678030 -380 127 2 0 3.549684 7.331168 1.175762 -381 127 2 0 3.816423 6.788603 2.602522 -382 128 1 0 3.892622 -7.034239 -6.415978 -383 128 2 0 4.720509 -6.539827 -6.295004 -384 128 2 0 3.262810 -6.550918 -5.890370 -385 129 1 0 5.454437 3.881722 -2.767521 -386 129 2 0 5.906266 3.240489 -3.272250 -387 129 2 0 6.116652 4.657253 -2.669082 -388 130 1 0 -4.179373 -8.326009 4.395005 -389 130 2 0 -3.737878 -8.754475 5.134173 -390 130 2 0 -3.934584 -8.825320 3.534465 -391 131 1 0 7.949488 -1.353498 9.244688 -392 131 2 0 7.234465 -1.100736 9.869694 -393 131 2 0 8.010855 -0.754076 8.476271 -394 132 1 0 4.498603 -4.219267 3.963173 -395 132 2 0 4.895226 -3.311215 4.147093 -396 132 2 0 4.802371 -4.871698 4.671292 -397 133 1 0 -4.307250 7.384668 -2.879462 -398 133 2 0 -3.402854 7.237543 -3.252031 -399 133 2 0 -4.143231 7.834459 -2.019767 -400 134 1 0 2.868752 -0.418389 1.909340 -401 134 2 0 2.544472 -0.880398 1.179279 -402 134 2 0 2.082841 -0.227627 2.457964 -403 135 1 0 7.961389 1.611971 4.525253 -404 135 2 0 7.498497 1.833174 3.728113 -405 135 2 0 8.841880 2.050996 4.576281 -406 136 1 0 2.692467 -4.517946 -0.884665 -407 136 2 0 1.789435 -4.835617 -0.587396 -408 136 2 0 3.330887 -5.126025 -0.474679 -409 137 1 0 0.711797 1.680547 -4.780435 -410 137 2 0 0.854596 1.567911 -3.850059 -411 137 2 0 -0.187286 1.868256 -4.936632 -412 138 1 0 4.558200 -0.044434 -4.673875 -413 138 2 0 5.376141 -0.551202 -4.913295 -414 138 2 0 4.409600 -0.197728 -3.739555 -415 139 1 0 7.109730 0.453475 -0.268844 -416 139 2 0 6.996444 0.098599 -1.119484 -417 139 2 0 6.343115 1.050849 -0.110689 -418 140 1 0 -2.549577 -0.200852 -4.492507 -419 140 2 0 -3.199039 -0.856439 -4.888752 -420 140 2 0 -2.605120 -0.151501 -3.534000 -421 141 1 0 -8.527353 4.524174 -2.347408 -422 141 2 0 -7.662213 4.342466 -2.104852 -423 141 2 0 -8.794374 3.696793 -2.795740 -424 142 1 0 -2.820431 -0.700478 4.413266 -425 142 2 0 -2.088343 -0.069797 4.530521 -426 142 2 0 -3.535913 -0.413547 5.069151 -427 143 1 0 6.924598 -1.285634 -4.901833 -428 143 2 0 7.496477 -0.831510 -4.206076 -429 143 2 0 7.527035 -1.446676 -5.677236 -430 144 1 0 -5.353763 6.572088 6.734366 -431 144 2 0 -4.428432 6.663173 6.834862 -432 144 2 0 -5.603600 6.385787 5.822425 -433 145 1 0 7.661597 2.386104 9.175259 -434 145 2 0 7.321694 2.395921 10.055536 -435 145 2 0 6.959141 2.102200 8.533079 -436 146 1 0 -3.496590 -3.765912 -4.994838 -437 146 2 0 -3.612181 -3.620689 -4.036115 -438 146 2 0 -4.323649 -3.527816 -5.463213 -439 147 1 0 -9.351953 8.343146 3.704719 -440 147 2 0 -8.465363 8.758592 3.736785 -441 147 2 0 -9.159223 7.399420 3.880808 -442 148 1 0 -0.957571 -5.174275 -2.190170 -443 148 2 0 -1.907345 -5.209294 -2.303164 -444 148 2 0 -0.758582 -4.314608 -2.636469 -445 149 1 0 5.048831 -7.988284 2.587515 -446 149 2 0 5.870168 -8.296198 3.043816 -447 149 2 0 4.551970 -7.498875 3.229280 -448 150 1 0 3.705658 8.368298 -8.304931 -449 150 2 0 3.860607 9.297256 -8.425405 -450 150 2 0 3.866516 8.146007 -7.371475 -451 151 1 0 -2.535134 7.116414 6.338590 -452 151 2 0 -1.918884 7.705593 6.804078 -453 151 2 0 -1.975225 6.330832 6.121365 -454 152 1 0 -3.440263 7.005018 9.111704 -455 152 2 0 -2.633953 7.421761 9.465848 -456 152 2 0 -3.654896 7.513753 8.256470 -457 153 1 0 6.452501 -5.478051 -5.722874 -458 153 2 0 7.297698 -5.914122 -5.586895 -459 153 2 0 6.253267 -4.919338 -4.937095 -460 154 1 0 -6.528475 4.497861 -5.573636 -461 154 2 0 -6.257840 4.684056 -4.656222 -462 154 2 0 -7.247764 3.931701 -5.623068 -463 155 1 0 -7.310706 8.183648 7.852201 -464 155 2 0 -6.552879 7.735013 7.436342 -465 155 2 0 -6.877865 8.451022 8.686616 -466 156 1 0 -1.476441 -7.867001 7.421787 -467 156 2 0 -0.852398 -8.570669 7.084405 -468 156 2 0 -1.363740 -7.190554 6.737331 -469 157 1 0 5.228019 -0.495870 -7.592953 -470 157 2 0 4.737616 -0.538139 -6.742036 -471 157 2 0 4.625354 -0.901329 -8.269022 -472 158 1 0 7.566531 -1.006734 1.808213 -473 158 2 0 7.657411 -1.866188 1.428564 -474 158 2 0 7.358547 -0.388051 1.139943 -475 159 1 0 1.850924 -5.717449 -5.035416 -476 159 2 0 1.721040 -6.227449 -4.217213 -477 159 2 0 2.199319 -4.856378 -4.692892 -478 160 1 0 -8.904325 6.791585 -3.842866 -479 160 2 0 -8.690637 5.952112 -3.490118 -480 160 2 0 -8.676001 6.844077 -4.770651 -481 161 1 0 -3.434304 4.397198 -7.863568 -482 161 2 0 -2.634777 3.892027 -7.779256 -483 161 2 0 -3.432847 5.161485 -7.310788 -484 162 1 0 -7.446738 6.124823 0.150068 -485 162 2 0 -7.404893 5.207959 0.481504 -486 162 2 0 -8.405563 6.215466 -0.024439 -487 163 1 0 0.195330 -7.307128 -3.501714 -488 163 2 0 -0.240912 -6.769004 -4.243655 -489 163 2 0 -0.194915 -6.981989 -2.679860 -490 164 1 0 7.068819 9.130323 7.260588 -491 164 2 0 6.559855 8.400987 7.699406 -492 164 2 0 7.972497 8.829223 7.213747 -493 165 1 0 -0.185218 -3.192290 -6.289346 -494 165 2 0 0.776651 -3.073203 -6.391948 -495 165 2 0 -0.497426 -2.964088 -7.170893 -496 166 1 0 -2.073630 4.369672 5.251074 -497 166 2 0 -1.868638 3.811508 6.060261 -498 166 2 0 -1.253174 4.326708 4.781680 -499 167 1 0 -0.855003 3.069108 -7.935226 -500 167 2 0 0.075758 3.132202 -7.617253 -501 167 2 0 -1.009845 2.207487 -8.320426 -502 168 1 0 -6.328833 0.064083 -8.467228 -503 168 2 0 -7.268416 0.384648 -8.383978 -504 168 2 0 -5.825246 0.919304 -8.320175 -505 169 1 0 -8.276352 -8.809851 -6.344910 -506 169 2 0 -7.541457 -8.792368 -5.688031 -507 169 2 0 -8.510208 -9.731116 -6.353248 -508 170 1 0 0.463654 2.826776 7.018388 -509 170 2 0 0.875324 3.588447 7.482107 -510 170 2 0 0.770257 2.126646 7.583650 -511 171 1 0 0.478371 -3.407198 6.910039 -512 171 2 0 0.585298 -2.996750 7.756467 -513 171 2 0 0.556531 -4.390636 7.183527 -514 172 1 0 -1.689559 7.002511 -3.303561 -515 172 2 0 -1.009152 7.635432 -3.553133 -516 172 2 0 -1.333699 6.195680 -2.919485 -517 173 1 0 9.000097 -6.227871 8.137681 -518 173 2 0 9.373858 -6.821152 7.497417 -519 173 2 0 8.024020 -6.011019 8.033727 -520 174 1 0 1.272378 1.954065 3.058033 -521 174 2 0 1.260842 2.615112 2.341207 -522 174 2 0 1.890312 2.223439 3.732934 -523 175 1 0 4.139066 -3.527427 -9.022609 -524 175 2 0 4.070028 -3.499117 -9.985525 -525 175 2 0 4.960292 -3.942364 -8.778433 -526 176 1 0 7.176276 2.178662 -4.075940 -527 176 2 0 6.995275 1.684022 -4.873223 -528 176 2 0 7.621313 2.984315 -4.393994 -529 177 1 0 -0.034836 -3.929919 2.148095 -530 177 2 0 0.838003 -3.513346 2.259663 -531 177 2 0 -0.654999 -3.288581 2.426748 -532 178 1 0 -8.701616 2.795237 -5.700842 -533 178 2 0 -8.848959 2.145603 -6.420186 -534 178 2 0 -9.464654 3.362988 -5.610379 -535 179 1 0 2.804444 8.909551 -5.635389 -536 179 2 0 3.063615 9.805993 -5.770957 -537 179 2 0 3.512196 8.486179 -5.165468 -538 180 1 0 3.236002 8.357402 3.636639 -539 180 2 0 3.450854 9.071799 3.073263 -540 180 2 0 3.476445 8.586691 4.607935 -541 181 1 0 5.628532 7.185941 8.510937 -542 181 2 0 5.467837 6.318153 8.138885 -543 181 2 0 4.964153 7.477925 9.150467 -544 182 1 0 -3.767261 1.260390 2.017681 -545 182 2 0 -3.707734 2.019520 2.565591 -546 182 2 0 -3.364602 1.609935 1.212351 -547 183 1 0 8.228917 -3.441761 0.850139 -548 183 2 0 9.022130 -3.709208 1.334881 -549 183 2 0 7.553662 -3.976731 1.276651 -550 184 1 0 -3.004292 1.345869 7.236734 -551 184 2 0 -3.715311 0.724731 6.912689 -552 184 2 0 -3.525684 2.111901 7.538936 -553 185 1 0 4.901423 -5.547141 -0.119795 -554 185 2 0 5.327550 -5.560969 0.769770 -555 185 2 0 5.447642 -4.930752 -0.617088 -556 186 1 0 -3.306210 8.469477 -0.495057 -557 186 2 0 -2.836855 9.122642 -1.080706 -558 186 2 0 -3.311215 8.916887 0.353875 -559 187 1 0 -6.572180 3.018421 -0.262079 -560 187 2 0 -6.711444 2.659956 0.606460 -561 187 2 0 -6.040782 2.473886 -0.843542 -562 188 1 0 -5.429147 -5.967833 5.177682 -563 188 2 0 -4.896648 -6.608203 4.692534 -564 188 2 0 -5.386594 -6.130690 6.117931 -565 189 1 0 6.054430 7.035601 0.031519 -566 189 2 0 5.939348 7.951184 -0.141094 -567 189 2 0 5.390949 6.866654 0.702638 -568 190 1 0 -0.890229 -2.615376 -3.621726 -569 190 2 0 -1.695442 -2.097314 -3.537976 -570 190 2 0 -0.895128 -2.637531 -4.561712 -571 191 1 0 -5.446979 0.994907 -2.106714 -572 191 2 0 -4.494883 0.997912 -1.881595 -573 191 2 0 -5.759736 0.094199 -1.919247 -574 192 1 0 -7.517688 -4.078340 7.202707 -575 192 2 0 -8.242348 -4.324693 7.729813 -576 192 2 0 -6.924399 -4.817453 7.269430 -577 193 1 0 -1.134884 8.628488 2.081069 -578 193 2 0 -1.962897 8.634713 2.554947 -579 193 2 0 -1.119731 7.882422 1.516003 -580 194 1 0 -6.288317 8.011683 2.022129 -581 194 2 0 -6.404647 8.858198 1.546109 -582 194 2 0 -6.669138 7.315199 1.482614 -583 195 1 0 -6.766934 -4.026505 -8.306645 -584 195 2 0 -6.542552 -4.855702 -8.828363 -585 195 2 0 -7.743726 -3.954163 -8.170031 -586 196 1 0 6.895244 7.052113 -3.031289 -587 196 2 0 7.810039 7.265357 -3.330751 -588 196 2 0 6.666757 7.541675 -2.202178 -589 197 1 0 8.003260 4.735929 -5.168656 -590 197 2 0 7.233375 4.730204 -5.685772 -591 197 2 0 8.406708 5.629580 -5.300038 -592 198 1 0 -5.230160 -6.461196 -4.390836 -593 198 2 0 -5.701559 -7.313756 -4.377348 -594 198 2 0 -4.855545 -6.327970 -5.273444 -595 199 1 0 -3.803496 -9.221115 7.305476 -596 199 2 0 -2.934288 -8.877999 7.425047 -597 199 2 0 -4.416066 -8.566250 7.573191 -598 200 1 0 -5.990438 -1.574415 3.072521 -599 200 2 0 -5.805447 -1.119293 3.933731 -600 200 2 0 -6.651651 -0.947206 2.634773 -601 201 1 0 1.155451 7.138377 -1.178317 -602 201 2 0 0.330359 7.363227 -0.724568 -603 201 2 0 1.055145 7.478676 -2.100793 -604 202 1 0 -5.886817 5.150957 -2.997276 -605 202 2 0 -5.191777 4.556623 -2.611465 -606 202 2 0 -5.401622 6.003350 -3.064194 -607 203 1 0 2.539927 3.387568 4.976180 -608 203 2 0 1.760904 3.182324 5.589217 -609 203 2 0 2.841539 4.315465 5.278853 -610 204 1 0 8.331859 -7.344673 -5.188191 -611 204 2 0 8.424401 -7.586778 -4.198621 -612 204 2 0 8.911675 -7.764424 -5.823267 -613 205 1 0 -5.774081 1.315144 -5.304553 -614 205 2 0 -5.222992 1.580336 -6.077077 -615 205 2 0 -6.219878 2.178441 -5.093360 -616 206 1 0 6.340084 -4.926064 2.149626 -617 206 2 0 5.639784 -4.766017 2.829591 -618 206 2 0 6.883511 -5.598794 2.562820 -619 207 1 0 -2.722394 6.614441 -5.843805 -620 207 2 0 -2.332414 7.251953 -6.403722 -621 207 2 0 -2.221682 6.596615 -5.034993 -622 208 1 0 -1.813152 0.712824 -9.048176 -623 208 2 0 -1.763921 -0.271744 -8.916841 -624 208 2 0 -2.097796 0.860500 -9.970314 -625 209 1 0 6.146244 -6.879929 8.376712 -626 209 2 0 5.324465 -7.183905 8.841506 -627 209 2 0 6.642264 -7.749945 8.201756 -628 210 1 0 2.887544 8.612615 0.453821 -629 210 2 0 2.452117 8.047637 -0.251289 -630 210 2 0 2.348751 9.285636 0.895642 -631 211 1 0 -8.475558 -8.180718 6.501232 -632 211 2 0 -8.034310 -8.945692 6.891221 -633 211 2 0 -8.173606 -8.179435 5.569319 -634 212 1 0 6.714205 -2.947903 6.551671 -635 212 2 0 7.143284 -2.459194 7.270891 -636 212 2 0 7.212365 -2.637046 5.791018 -637 213 1 0 6.445003 -5.462306 5.577966 -638 213 2 0 6.730099 -4.696457 6.073312 -639 213 2 0 6.099428 -6.099736 6.222859 -640 214 1 0 -1.818761 -6.080111 -8.805420 -641 214 2 0 -1.644534 -6.777931 -9.477669 -642 214 2 0 -2.078582 -5.258591 -9.215838 -643 215 1 0 6.037377 2.950576 2.863541 -644 215 2 0 6.409766 3.757001 2.570754 -645 215 2 0 5.577033 2.617474 2.090587 -646 216 1 0 -7.731645 3.337668 3.301121 -647 216 2 0 -8.345957 4.027222 3.589257 -648 216 2 0 -8.130328 2.845238 2.577949 - -Bonds - -1 1 1 2 -2 1 1 3 -3 1 4 5 -4 1 4 6 -5 1 7 8 -6 1 7 9 -7 1 10 11 -8 1 10 12 -9 1 13 14 -10 1 13 15 -11 1 16 17 -12 1 16 18 -13 1 19 20 -14 1 19 21 -15 1 22 23 -16 1 22 24 -17 1 25 26 -18 1 25 27 -19 1 28 29 -20 1 28 30 -21 1 31 32 -22 1 31 33 -23 1 34 35 -24 1 34 36 -25 1 37 38 -26 1 37 39 -27 1 40 41 -28 1 40 42 -29 1 43 44 -30 1 43 45 -31 1 46 47 -32 1 46 48 -33 1 49 50 -34 1 49 51 -35 1 52 53 -36 1 52 54 -37 1 55 56 -38 1 55 57 -39 1 58 59 -40 1 58 60 -41 1 61 62 -42 1 61 63 -43 1 64 65 -44 1 64 66 -45 1 67 68 -46 1 67 69 -47 1 70 71 -48 1 70 72 -49 1 73 74 -50 1 73 75 -51 1 76 77 -52 1 76 78 -53 1 79 80 -54 1 79 81 -55 1 82 83 -56 1 82 84 -57 1 85 86 -58 1 85 87 -59 1 88 89 -60 1 88 90 -61 1 91 92 -62 1 91 93 -63 1 94 95 -64 1 94 96 -65 1 97 98 -66 1 97 99 -67 1 100 101 -68 1 100 102 -69 1 103 104 -70 1 103 105 -71 1 106 107 -72 1 106 108 -73 1 109 110 -74 1 109 111 -75 1 112 113 -76 1 112 114 -77 1 115 116 -78 1 115 117 -79 1 118 119 -80 1 118 120 -81 1 121 122 -82 1 121 123 -83 1 124 125 -84 1 124 126 -85 1 127 128 -86 1 127 129 -87 1 130 131 -88 1 130 132 -89 1 133 134 -90 1 133 135 -91 1 136 137 -92 1 136 138 -93 1 139 140 -94 1 139 141 -95 1 142 143 -96 1 142 144 -97 1 145 146 -98 1 145 147 -99 1 148 149 -100 1 148 150 -101 1 151 152 -102 1 151 153 -103 1 154 155 -104 1 154 156 -105 1 157 158 -106 1 157 159 -107 1 160 161 -108 1 160 162 -109 1 163 164 -110 1 163 165 -111 1 166 167 -112 1 166 168 -113 1 169 170 -114 1 169 171 -115 1 172 173 -116 1 172 174 -117 1 175 176 -118 1 175 177 -119 1 178 179 -120 1 178 180 -121 1 181 182 -122 1 181 183 -123 1 184 185 -124 1 184 186 -125 1 187 188 -126 1 187 189 -127 1 190 191 -128 1 190 192 -129 1 193 194 -130 1 193 195 -131 1 196 197 -132 1 196 198 -133 1 199 200 -134 1 199 201 -135 1 202 203 -136 1 202 204 -137 1 205 206 -138 1 205 207 -139 1 208 209 -140 1 208 210 -141 1 211 212 -142 1 211 213 -143 1 214 215 -144 1 214 216 -145 1 217 218 -146 1 217 219 -147 1 220 221 -148 1 220 222 -149 1 223 224 -150 1 223 225 -151 1 226 227 -152 1 226 228 -153 1 229 230 -154 1 229 231 -155 1 232 233 -156 1 232 234 -157 1 235 236 -158 1 235 237 -159 1 238 239 -160 1 238 240 -161 1 241 242 -162 1 241 243 -163 1 244 245 -164 1 244 246 -165 1 247 248 -166 1 247 249 -167 1 250 251 -168 1 250 252 -169 1 253 254 -170 1 253 255 -171 1 256 257 -172 1 256 258 -173 1 259 260 -174 1 259 261 -175 1 262 263 -176 1 262 264 -177 1 265 266 -178 1 265 267 -179 1 268 269 -180 1 268 270 -181 1 271 272 -182 1 271 273 -183 1 274 275 -184 1 274 276 -185 1 277 278 -186 1 277 279 -187 1 280 281 -188 1 280 282 -189 1 283 284 -190 1 283 285 -191 1 286 287 -192 1 286 288 -193 1 289 290 -194 1 289 291 -195 1 292 293 -196 1 292 294 -197 1 295 296 -198 1 295 297 -199 1 298 299 -200 1 298 300 -201 1 301 302 -202 1 301 303 -203 1 304 305 -204 1 304 306 -205 1 307 308 -206 1 307 309 -207 1 310 311 -208 1 310 312 -209 1 313 314 -210 1 313 315 -211 1 316 317 -212 1 316 318 -213 1 319 320 -214 1 319 321 -215 1 322 323 -216 1 322 324 -217 1 325 326 -218 1 325 327 -219 1 328 329 -220 1 328 330 -221 1 331 332 -222 1 331 333 -223 1 334 335 -224 1 334 336 -225 1 337 338 -226 1 337 339 -227 1 340 341 -228 1 340 342 -229 1 343 344 -230 1 343 345 -231 1 346 347 -232 1 346 348 -233 1 349 350 -234 1 349 351 -235 1 352 353 -236 1 352 354 -237 1 355 356 -238 1 355 357 -239 1 358 359 -240 1 358 360 -241 1 361 362 -242 1 361 363 -243 1 364 365 -244 1 364 366 -245 1 367 368 -246 1 367 369 -247 1 370 371 -248 1 370 372 -249 1 373 374 -250 1 373 375 -251 1 376 377 -252 1 376 378 -253 1 379 380 -254 1 379 381 -255 1 382 383 -256 1 382 384 -257 1 385 386 -258 1 385 387 -259 1 388 389 -260 1 388 390 -261 1 391 392 -262 1 391 393 -263 1 394 395 -264 1 394 396 -265 1 397 398 -266 1 397 399 -267 1 400 401 -268 1 400 402 -269 1 403 404 -270 1 403 405 -271 1 406 407 -272 1 406 408 -273 1 409 410 -274 1 409 411 -275 1 412 413 -276 1 412 414 -277 1 415 416 -278 1 415 417 -279 1 418 419 -280 1 418 420 -281 1 421 422 -282 1 421 423 -283 1 424 425 -284 1 424 426 -285 1 427 428 -286 1 427 429 -287 1 430 431 -288 1 430 432 -289 1 433 434 -290 1 433 435 -291 1 436 437 -292 1 436 438 -293 1 439 440 -294 1 439 441 -295 1 442 443 -296 1 442 444 -297 1 445 446 -298 1 445 447 -299 1 448 449 -300 1 448 450 -301 1 451 452 -302 1 451 453 -303 1 454 455 -304 1 454 456 -305 1 457 458 -306 1 457 459 -307 1 460 461 -308 1 460 462 -309 1 463 464 -310 1 463 465 -311 1 466 467 -312 1 466 468 -313 1 469 470 -314 1 469 471 -315 1 472 473 -316 1 472 474 -317 1 475 476 -318 1 475 477 -319 1 478 479 -320 1 478 480 -321 1 481 482 -322 1 481 483 -323 1 484 485 -324 1 484 486 -325 1 487 488 -326 1 487 489 -327 1 490 491 -328 1 490 492 -329 1 493 494 -330 1 493 495 -331 1 496 497 -332 1 496 498 -333 1 499 500 -334 1 499 501 -335 1 502 503 -336 1 502 504 -337 1 505 506 -338 1 505 507 -339 1 508 509 -340 1 508 510 -341 1 511 512 -342 1 511 513 -343 1 514 515 -344 1 514 516 -345 1 517 518 -346 1 517 519 -347 1 520 521 -348 1 520 522 -349 1 523 524 -350 1 523 525 -351 1 526 527 -352 1 526 528 -353 1 529 530 -354 1 529 531 -355 1 532 533 -356 1 532 534 -357 1 535 536 -358 1 535 537 -359 1 538 539 -360 1 538 540 -361 1 541 542 -362 1 541 543 -363 1 544 545 -364 1 544 546 -365 1 547 548 -366 1 547 549 -367 1 550 551 -368 1 550 552 -369 1 553 554 -370 1 553 555 -371 1 556 557 -372 1 556 558 -373 1 559 560 -374 1 559 561 -375 1 562 563 -376 1 562 564 -377 1 565 566 -378 1 565 567 -379 1 568 569 -380 1 568 570 -381 1 571 572 -382 1 571 573 -383 1 574 575 -384 1 574 576 -385 1 577 578 -386 1 577 579 -387 1 580 581 -388 1 580 582 -389 1 583 584 -390 1 583 585 -391 1 586 587 -392 1 586 588 -393 1 589 590 -394 1 589 591 -395 1 592 593 -396 1 592 594 -397 1 595 596 -398 1 595 597 -399 1 598 599 -400 1 598 600 -401 1 601 602 -402 1 601 603 -403 1 604 605 -404 1 604 606 -405 1 607 608 -406 1 607 609 -407 1 610 611 -408 1 610 612 -409 1 613 614 -410 1 613 615 -411 1 616 617 -412 1 616 618 -413 1 619 620 -414 1 619 621 -415 1 622 623 -416 1 622 624 -417 1 625 626 -418 1 625 627 -419 1 628 629 -420 1 628 630 -421 1 631 632 -422 1 631 633 -423 1 634 635 -424 1 634 636 -425 1 637 638 -426 1 637 639 -427 1 640 641 -428 1 640 642 -429 1 643 644 -430 1 643 645 -431 1 646 647 -432 1 646 648 - -Angles - -1 1 2 1 3 -2 1 5 4 6 -3 1 8 7 9 -4 1 11 10 12 -5 1 14 13 15 -6 1 17 16 18 -7 1 20 19 21 -8 1 23 22 24 -9 1 26 25 27 -10 1 29 28 30 -11 1 32 31 33 -12 1 35 34 36 -13 1 38 37 39 -14 1 41 40 42 -15 1 44 43 45 -16 1 47 46 48 -17 1 50 49 51 -18 1 53 52 54 -19 1 56 55 57 -20 1 59 58 60 -21 1 62 61 63 -22 1 65 64 66 -23 1 68 67 69 -24 1 71 70 72 -25 1 74 73 75 -26 1 77 76 78 -27 1 80 79 81 -28 1 83 82 84 -29 1 86 85 87 -30 1 89 88 90 -31 1 92 91 93 -32 1 95 94 96 -33 1 98 97 99 -34 1 101 100 102 -35 1 104 103 105 -36 1 107 106 108 -37 1 110 109 111 -38 1 113 112 114 -39 1 116 115 117 -40 1 119 118 120 -41 1 122 121 123 -42 1 125 124 126 -43 1 128 127 129 -44 1 131 130 132 -45 1 134 133 135 -46 1 137 136 138 -47 1 140 139 141 -48 1 143 142 144 -49 1 146 145 147 -50 1 149 148 150 -51 1 152 151 153 -52 1 155 154 156 -53 1 158 157 159 -54 1 161 160 162 -55 1 164 163 165 -56 1 167 166 168 -57 1 170 169 171 -58 1 173 172 174 -59 1 176 175 177 -60 1 179 178 180 -61 1 182 181 183 -62 1 185 184 186 -63 1 188 187 189 -64 1 191 190 192 -65 1 194 193 195 -66 1 197 196 198 -67 1 200 199 201 -68 1 203 202 204 -69 1 206 205 207 -70 1 209 208 210 -71 1 212 211 213 -72 1 215 214 216 -73 1 218 217 219 -74 1 221 220 222 -75 1 224 223 225 -76 1 227 226 228 -77 1 230 229 231 -78 1 233 232 234 -79 1 236 235 237 -80 1 239 238 240 -81 1 242 241 243 -82 1 245 244 246 -83 1 248 247 249 -84 1 251 250 252 -85 1 254 253 255 -86 1 257 256 258 -87 1 260 259 261 -88 1 263 262 264 -89 1 266 265 267 -90 1 269 268 270 -91 1 272 271 273 -92 1 275 274 276 -93 1 278 277 279 -94 1 281 280 282 -95 1 284 283 285 -96 1 287 286 288 -97 1 290 289 291 -98 1 293 292 294 -99 1 296 295 297 -100 1 299 298 300 -101 1 302 301 303 -102 1 305 304 306 -103 1 308 307 309 -104 1 311 310 312 -105 1 314 313 315 -106 1 317 316 318 -107 1 320 319 321 -108 1 323 322 324 -109 1 326 325 327 -110 1 329 328 330 -111 1 332 331 333 -112 1 335 334 336 -113 1 338 337 339 -114 1 341 340 342 -115 1 344 343 345 -116 1 347 346 348 -117 1 350 349 351 -118 1 353 352 354 -119 1 356 355 357 -120 1 359 358 360 -121 1 362 361 363 -122 1 365 364 366 -123 1 368 367 369 -124 1 371 370 372 -125 1 374 373 375 -126 1 377 376 378 -127 1 380 379 381 -128 1 383 382 384 -129 1 386 385 387 -130 1 389 388 390 -131 1 392 391 393 -132 1 395 394 396 -133 1 398 397 399 -134 1 401 400 402 -135 1 404 403 405 -136 1 407 406 408 -137 1 410 409 411 -138 1 413 412 414 -139 1 416 415 417 -140 1 419 418 420 -141 1 422 421 423 -142 1 425 424 426 -143 1 428 427 429 -144 1 431 430 432 -145 1 434 433 435 -146 1 437 436 438 -147 1 440 439 441 -148 1 443 442 444 -149 1 446 445 447 -150 1 449 448 450 -151 1 452 451 453 -152 1 455 454 456 -153 1 458 457 459 -154 1 461 460 462 -155 1 464 463 465 -156 1 467 466 468 -157 1 470 469 471 -158 1 473 472 474 -159 1 476 475 477 -160 1 479 478 480 -161 1 482 481 483 -162 1 485 484 486 -163 1 488 487 489 -164 1 491 490 492 -165 1 494 493 495 -166 1 497 496 498 -167 1 500 499 501 -168 1 503 502 504 -169 1 506 505 507 -170 1 509 508 510 -171 1 512 511 513 -172 1 515 514 516 -173 1 518 517 519 -174 1 521 520 522 -175 1 524 523 525 -176 1 527 526 528 -177 1 530 529 531 -178 1 533 532 534 -179 1 536 535 537 -180 1 539 538 540 -181 1 542 541 543 -182 1 545 544 546 -183 1 548 547 549 -184 1 551 550 552 -185 1 554 553 555 -186 1 557 556 558 -187 1 560 559 561 -188 1 563 562 564 -189 1 566 565 567 -190 1 569 568 570 -191 1 572 571 573 -192 1 575 574 576 -193 1 578 577 579 -194 1 581 580 582 -195 1 584 583 585 -196 1 587 586 588 -197 1 590 589 591 -198 1 593 592 594 -199 1 596 595 597 -200 1 599 598 600 -201 1 602 601 603 -202 1 605 604 606 -203 1 608 607 609 -204 1 611 610 612 -205 1 614 613 615 -206 1 617 616 618 -207 1 620 619 621 -208 1 623 622 624 -209 1 626 625 627 -210 1 629 628 630 -211 1 632 631 633 -212 1 635 634 636 -213 1 638 637 639 -214 1 641 640 642 -215 1 644 643 645 -216 1 647 646 648 - -Bond Coeffs - -1 0.9572 556.85 -1419.9675 2112.20165625 - -Angle Coeffs - -1 0 108.5 48.7 -39.064262472 8.95286947775 -6.41202044508 11.5462823034 - -Tinker Types - -1 1 -2 2 -3 2 -4 1 -5 2 -6 2 -7 1 -8 2 -9 2 -10 1 -11 2 -12 2 -13 1 -14 2 -15 2 -16 1 -17 2 -18 2 -19 1 -20 2 -21 2 -22 1 -23 2 -24 2 -25 1 -26 2 -27 2 -28 1 -29 2 -30 2 -31 1 -32 2 -33 2 -34 1 -35 2 -36 2 -37 1 -38 2 -39 2 -40 1 -41 2 -42 2 -43 1 -44 2 -45 2 -46 1 -47 2 -48 2 -49 1 -50 2 -51 2 -52 1 -53 2 -54 2 -55 1 -56 2 -57 2 -58 1 -59 2 -60 2 -61 1 -62 2 -63 2 -64 1 -65 2 -66 2 -67 1 -68 2 -69 2 -70 1 -71 2 -72 2 -73 1 -74 2 -75 2 -76 1 -77 2 -78 2 -79 1 -80 2 -81 2 -82 1 -83 2 -84 2 -85 1 -86 2 -87 2 -88 1 -89 2 -90 2 -91 1 -92 2 -93 2 -94 1 -95 2 -96 2 -97 1 -98 2 -99 2 -100 1 -101 2 -102 2 -103 1 -104 2 -105 2 -106 1 -107 2 -108 2 -109 1 -110 2 -111 2 -112 1 -113 2 -114 2 -115 1 -116 2 -117 2 -118 1 -119 2 -120 2 -121 1 -122 2 -123 2 -124 1 -125 2 -126 2 -127 1 -128 2 -129 2 -130 1 -131 2 -132 2 -133 1 -134 2 -135 2 -136 1 -137 2 -138 2 -139 1 -140 2 -141 2 -142 1 -143 2 -144 2 -145 1 -146 2 -147 2 -148 1 -149 2 -150 2 -151 1 -152 2 -153 2 -154 1 -155 2 -156 2 -157 1 -158 2 -159 2 -160 1 -161 2 -162 2 -163 1 -164 2 -165 2 -166 1 -167 2 -168 2 -169 1 -170 2 -171 2 -172 1 -173 2 -174 2 -175 1 -176 2 -177 2 -178 1 -179 2 -180 2 -181 1 -182 2 -183 2 -184 1 -185 2 -186 2 -187 1 -188 2 -189 2 -190 1 -191 2 -192 2 -193 1 -194 2 -195 2 -196 1 -197 2 -198 2 -199 1 -200 2 -201 2 -202 1 -203 2 -204 2 -205 1 -206 2 -207 2 -208 1 -209 2 -210 2 -211 1 -212 2 -213 2 -214 1 -215 2 -216 2 -217 1 -218 2 -219 2 -220 1 -221 2 -222 2 -223 1 -224 2 -225 2 -226 1 -227 2 -228 2 -229 1 -230 2 -231 2 -232 1 -233 2 -234 2 -235 1 -236 2 -237 2 -238 1 -239 2 -240 2 -241 1 -242 2 -243 2 -244 1 -245 2 -246 2 -247 1 -248 2 -249 2 -250 1 -251 2 -252 2 -253 1 -254 2 -255 2 -256 1 -257 2 -258 2 -259 1 -260 2 -261 2 -262 1 -263 2 -264 2 -265 1 -266 2 -267 2 -268 1 -269 2 -270 2 -271 1 -272 2 -273 2 -274 1 -275 2 -276 2 -277 1 -278 2 -279 2 -280 1 -281 2 -282 2 -283 1 -284 2 -285 2 -286 1 -287 2 -288 2 -289 1 -290 2 -291 2 -292 1 -293 2 -294 2 -295 1 -296 2 -297 2 -298 1 -299 2 -300 2 -301 1 -302 2 -303 2 -304 1 -305 2 -306 2 -307 1 -308 2 -309 2 -310 1 -311 2 -312 2 -313 1 -314 2 -315 2 -316 1 -317 2 -318 2 -319 1 -320 2 -321 2 -322 1 -323 2 -324 2 -325 1 -326 2 -327 2 -328 1 -329 2 -330 2 -331 1 -332 2 -333 2 -334 1 -335 2 -336 2 -337 1 -338 2 -339 2 -340 1 -341 2 -342 2 -343 1 -344 2 -345 2 -346 1 -347 2 -348 2 -349 1 -350 2 -351 2 -352 1 -353 2 -354 2 -355 1 -356 2 -357 2 -358 1 -359 2 -360 2 -361 1 -362 2 -363 2 -364 1 -365 2 -366 2 -367 1 -368 2 -369 2 -370 1 -371 2 -372 2 -373 1 -374 2 -375 2 -376 1 -377 2 -378 2 -379 1 -380 2 -381 2 -382 1 -383 2 -384 2 -385 1 -386 2 -387 2 -388 1 -389 2 -390 2 -391 1 -392 2 -393 2 -394 1 -395 2 -396 2 -397 1 -398 2 -399 2 -400 1 -401 2 -402 2 -403 1 -404 2 -405 2 -406 1 -407 2 -408 2 -409 1 -410 2 -411 2 -412 1 -413 2 -414 2 -415 1 -416 2 -417 2 -418 1 -419 2 -420 2 -421 1 -422 2 -423 2 -424 1 -425 2 -426 2 -427 1 -428 2 -429 2 -430 1 -431 2 -432 2 -433 1 -434 2 -435 2 -436 1 -437 2 -438 2 -439 1 -440 2 -441 2 -442 1 -443 2 -444 2 -445 1 -446 2 -447 2 -448 1 -449 2 -450 2 -451 1 -452 2 -453 2 -454 1 -455 2 -456 2 -457 1 -458 2 -459 2 -460 1 -461 2 -462 2 -463 1 -464 2 -465 2 -466 1 -467 2 -468 2 -469 1 -470 2 -471 2 -472 1 -473 2 -474 2 -475 1 -476 2 -477 2 -478 1 -479 2 -480 2 -481 1 -482 2 -483 2 -484 1 -485 2 -486 2 -487 1 -488 2 -489 2 -490 1 -491 2 -492 2 -493 1 -494 2 -495 2 -496 1 -497 2 -498 2 -499 1 -500 2 -501 2 -502 1 -503 2 -504 2 -505 1 -506 2 -507 2 -508 1 -509 2 -510 2 -511 1 -512 2 -513 2 -514 1 -515 2 -516 2 -517 1 -518 2 -519 2 -520 1 -521 2 -522 2 -523 1 -524 2 -525 2 -526 1 -527 2 -528 2 -529 1 -530 2 -531 2 -532 1 -533 2 -534 2 -535 1 -536 2 -537 2 -538 1 -539 2 -540 2 -541 1 -542 2 -543 2 -544 1 -545 2 -546 2 -547 1 -548 2 -549 2 -550 1 -551 2 -552 2 -553 1 -554 2 -555 2 -556 1 -557 2 -558 2 -559 1 -560 2 -561 2 -562 1 -563 2 -564 2 -565 1 -566 2 -567 2 -568 1 -569 2 -570 2 -571 1 -572 2 -573 2 -574 1 -575 2 -576 2 -577 1 -578 2 -579 2 -580 1 -581 2 -582 2 -583 1 -584 2 -585 2 -586 1 -587 2 -588 2 -589 1 -590 2 -591 2 -592 1 -593 2 -594 2 -595 1 -596 2 -597 2 -598 1 -599 2 -600 2 -601 1 -602 2 -603 2 -604 1 -605 2 -606 2 -607 1 -608 2 -609 2 -610 1 -611 2 -612 2 -613 1 -614 2 -615 2 -616 1 -617 2 -618 2 -619 1 -620 2 -621 2 -622 1 -623 2 -624 2 -625 1 -626 2 -627 2 -628 1 -629 2 -630 2 -631 1 -632 2 -633 2 -634 1 -635 2 -636 2 -637 1 -638 2 -639 2 -640 1 -641 2 -642 2 -643 1 -644 2 -645 2 -646 1 -647 2 -648 2 From 29d5505f439a17a84d7055f142f7def6c50ac367 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Thu, 26 Aug 2021 15:10:59 -0600 Subject: [PATCH 038/585] remove debug line --- src/AMOEBA/angle_amoeba.cpp | 2 ++ 1 file changed, 2 insertions(+) diff --git a/src/AMOEBA/angle_amoeba.cpp b/src/AMOEBA/angle_amoeba.cpp index a82f390a84..4476615a50 100644 --- a/src/AMOEBA/angle_amoeba.cpp +++ b/src/AMOEBA/angle_amoeba.cpp @@ -290,12 +290,14 @@ void AngleAmoeba::anglep(int i1, int i2, int i3, int type, int eflag) if (eflag) eangle = k2[type]*dtheta2 + k3[type]*dtheta3 + k4[type]*dtheta4 + k5[type]*dtheta5 + k6[type]*dtheta6; + /* printf("ANGLEP: %d %d %d %d: eng %g\n", atom->tag[i1], atom->tag[i2], atom->tag[i3], atom->tag[i4], eangle); + */ // chain rule terms for first derivative components From 115d8d7c4487a4328e2a12c07851b037679dfb27 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Thu, 26 Aug 2021 15:12:02 -0600 Subject: [PATCH 039/585] update Tinker conversion tool --- tools/tinker2lmp.py | 4 +++- 1 file changed, 3 insertions(+), 1 deletion(-) diff --git a/tools/tinker2lmp.py b/tools/tinker2lmp.py index 3f5bb90f8a..9b4aec3a5f 100644 --- a/tools/tinker2lmp.py +++ b/tools/tinker2lmp.py @@ -194,7 +194,9 @@ class PRMfile: if iline < 0: return params iline += 3 while iline < self.nlines: - words = self.lines[iline].split() + line = self.lines[iline] + line = line[:line.find("!!")] + words = line.split() if len(words): if words[0].startswith("###########"): break if words[0] == "angle" or words[0] == "anglep": From e857911088e6194f6ea49aec748b16f1efbf1ea4 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Thu, 26 Aug 2021 15:52:16 -0600 Subject: [PATCH 040/585] add null check to new 4d memory method --- src/memory.h | 4 ++++ 1 file changed, 4 insertions(+) diff --git a/src/memory.h b/src/memory.h index 67aadfe26f..5070398dce 100644 --- a/src/memory.h +++ b/src/memory.h @@ -524,6 +524,8 @@ class Memory : protected Pointers { TYPE ****create4d_offset(TYPE ****&array, int n1, int n2lo, int n2hi, int n3lo, int n3hi, int n4lo, int n4hi, const char *name) { + if (n1 <= 0 || n2lo > n2hi || n3lo > n3hi || n4lo > n4hi) return nullptr; + int n2 = n2hi - n2lo + 1; int n3 = n3hi - n3lo + 1; int n4 = n4hi - n4lo + 1; @@ -573,6 +575,8 @@ class Memory : protected Pointers { int n2lo, int n2hi, int n3lo, int n3hi, int n4, const char *name) { + if (n1lo > n1hi || n2lo > n2hi || n3lo > n3hi || n4 <= 0) return nullptr; + int n1 = n1hi - n1lo + 1; int n2 = n2hi - n2lo + 1; int n3 = n3hi - n3lo + 1; From b6187b19895bc9e273caa1cb350ab905140a9b8f Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Thu, 26 Aug 2021 15:53:31 -0600 Subject: [PATCH 041/585] add null check to new 4d memory method --- src/memory.h | 2 -- 1 file changed, 2 deletions(-) diff --git a/src/memory.h b/src/memory.h index 5070398dce..423f4df594 100644 --- a/src/memory.h +++ b/src/memory.h @@ -524,8 +524,6 @@ class Memory : protected Pointers { TYPE ****create4d_offset(TYPE ****&array, int n1, int n2lo, int n2hi, int n3lo, int n3hi, int n4lo, int n4hi, const char *name) { - if (n1 <= 0 || n2lo > n2hi || n3lo > n3hi || n4lo > n4hi) return nullptr; - int n2 = n2hi - n2lo + 1; int n3 = n3hi - n3lo + 1; int n4 = n4hi - n4lo + 1; From 7eba43938815af5bd9840cf3db8af0ede9060dfa Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Mon, 27 Sep 2021 14:29:11 -0600 Subject: [PATCH 042/585] add special_bonds command to water examples --- examples/amoeba/in.water_box.amoeba | 2 ++ examples/amoeba/in.water_box.hippo | 2 ++ examples/amoeba/in.water_dimer.amoeba | 2 ++ examples/amoeba/in.water_dimer.hippo | 2 ++ examples/amoeba/in.water_hexamer.amoeba | 2 ++ examples/amoeba/in.water_hexamer.hippo | 2 ++ 6 files changed, 12 insertions(+) diff --git a/examples/amoeba/in.water_box.amoeba b/examples/amoeba/in.water_box.amoeba index 63ada708f7..da816783f7 100644 --- a/examples/amoeba/in.water_box.amoeba +++ b/examples/amoeba/in.water_box.amoeba @@ -24,6 +24,8 @@ read_data data.water_box.amoeba fix amtype NULL "Tinker Types" pair_style amoeba pair_coeff * * amoeba_water.prm amoeba_water.key +special_bonds lj/coul 0.5 0.5 0.5 one/five yes + # thermo output compute virial all pressure NULL virial diff --git a/examples/amoeba/in.water_box.hippo b/examples/amoeba/in.water_box.hippo index 6547a135b6..4c11bc66d0 100644 --- a/examples/amoeba/in.water_box.hippo +++ b/examples/amoeba/in.water_box.hippo @@ -24,6 +24,8 @@ read_data data.water_box.hippo fix amtype NULL "Tinker Types" pair_style hippo pair_coeff * * hippo_water.prm hippo_water.key +special_bonds lj/coul 0.5 0.5 0.5 one/five yes + # thermo output compute virial all pressure NULL virial diff --git a/examples/amoeba/in.water_dimer.amoeba b/examples/amoeba/in.water_dimer.amoeba index af22009269..1573f87df8 100644 --- a/examples/amoeba/in.water_dimer.amoeba +++ b/examples/amoeba/in.water_dimer.amoeba @@ -24,6 +24,8 @@ read_data data.water_dimer.amoeba fix amtype NULL "Tinker Types" pair_style amoeba pair_coeff * * amoeba_water.prm amoeba_water.key +special_bonds lj/coul 0.5 0.5 0.5 one/five yes + # thermo output compute virial all pressure NULL virial diff --git a/examples/amoeba/in.water_dimer.hippo b/examples/amoeba/in.water_dimer.hippo index b19cbc0f26..c94900c929 100644 --- a/examples/amoeba/in.water_dimer.hippo +++ b/examples/amoeba/in.water_dimer.hippo @@ -24,6 +24,8 @@ read_data data.water_dimer.hippo fix amtype NULL "Tinker Types" pair_style hippo pair_coeff * * hippo_water.prm hippo_water.key +special_bonds lj/coul 0.5 0.5 0.5 one/five yes + # thermo output compute virial all pressure NULL virial diff --git a/examples/amoeba/in.water_hexamer.amoeba b/examples/amoeba/in.water_hexamer.amoeba index cafab56053..b50d0f25df 100644 --- a/examples/amoeba/in.water_hexamer.amoeba +++ b/examples/amoeba/in.water_hexamer.amoeba @@ -24,6 +24,8 @@ read_data data.water_hexamer.amoeba fix amtype NULL "Tinker Types" pair_style amoeba pair_coeff * * amoeba_water.prm amoeba_water.key +special_bonds lj/coul 0.5 0.5 0.5 one/five yes + # thermo output compute virial all pressure NULL virial diff --git a/examples/amoeba/in.water_hexamer.hippo b/examples/amoeba/in.water_hexamer.hippo index 27cdb6e634..c3ece34c23 100644 --- a/examples/amoeba/in.water_hexamer.hippo +++ b/examples/amoeba/in.water_hexamer.hippo @@ -24,6 +24,8 @@ read_data data.water_hexamer.hippo fix amtype NULL "Tinker Types" pair_style hippo pair_coeff * * hippo_water.prm hippo_water.key +special_bonds lj/coul 0.5 0.5 0.5 one/five yes + # thermo output compute virial all pressure NULL virial From 8bddc801df643bf69f8c1a4c3798646dc46a130f Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Sun, 3 Oct 2021 17:55:55 -0600 Subject: [PATCH 043/585] First successful compile of pair style --- src/ML-SNAP/pair_sna_grid.cpp | 182 ++++++++++++++++++ src/ML-SNAP/pair_sna_grid.h | 76 ++++++++ src/pair_grid.cpp | 344 ++++++++++++++++++++++++++++++++++ src/pair_grid.h | 88 +++++++++ 4 files changed, 690 insertions(+) create mode 100644 src/ML-SNAP/pair_sna_grid.cpp create mode 100644 src/ML-SNAP/pair_sna_grid.h create mode 100644 src/pair_grid.cpp create mode 100644 src/pair_grid.h diff --git a/src/ML-SNAP/pair_sna_grid.cpp b/src/ML-SNAP/pair_sna_grid.cpp new file mode 100644 index 0000000000..605e05ebf9 --- /dev/null +++ b/src/ML-SNAP/pair_sna_grid.cpp @@ -0,0 +1,182 @@ +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#include "pair_grid.h" +#include "pair_sna_grid.h" +#include "sna.h" +#include "atom.h" +#include "update.h" +#include "modify.h" +#include "neighbor.h" +#include "neigh_list.h" +#include "neigh_request.h" +#include "force.h" +#include "pair.h" +#include "domain.h" +#include "comm.h" +#include "memory.h" +#include "error.h" +#include "tokenizer.h" + +#include +#include + +using namespace LAMMPS_NS; + +PairSNAGrid::PairSNAGrid(LAMMPS *lmp) : + PairGrid(lmp), cutsq(nullptr), + radelem(nullptr), wjelem(nullptr) +{ +} + +/* ---------------------------------------------------------------------- */ + +PairSNAGrid::~PairSNAGrid() +{ + memory->destroy(radelem); + memory->destroy(wjelem); + memory->destroy(cutsq); + delete snaptr; + + if (chemflag) memory->destroy(map); +} + +/* ---------------------------------------------------------------------- */ + +void PairSNAGrid::init() +{ + if (force->pair == nullptr) + error->all(FLERR,"Pair sna/grid requires a pair style be defined"); + + if (cutmax > force->pair->cutforce) + error->all(FLERR,"Pair sna/grid cutoff is longer than pairwise cutoff"); + + // need an occasional full neighbor list + + int irequest = neighbor->request(this,instance_me); + neighbor->requests[irequest]->pair = 0; + neighbor->requests[irequest]->compute = 1; + neighbor->requests[irequest]->half = 0; + neighbor->requests[irequest]->full = 1; + neighbor->requests[irequest]->occasional = 1; + + snaptr->init(); +} + +/* ---------------------------------------------------------------------- */ + +void PairSNAGrid::init_list(int /*id*/, NeighList *ptr) +{ + list = ptr; +} + +/* ---------------------------------------------------------------------- */ + +void PairSNAGrid::compute(int eflag, int vflag) +{ + + // compute sna for each gridpoint + + double** const x = atom->x; + const int* const mask = atom->mask; + int * const type = atom->type; + const int ntotal = atom->nlocal + atom->nghost; + + // insure rij, inside, and typej are of size jnum + + snaptr->grow_rij(ntotal); + + for (int iz = nzlo; iz <= nzhi; iz++) + for (int iy = nylo; iy <= nyhi; iy++) + for (int ix = nxlo; ix <= nxhi; ix++) { + double xgrid[3]; + grid2x(ix, iy, iz, xgrid); + const double xtmp = xgrid[0]; + const double ytmp = xgrid[1]; + const double ztmp = xgrid[2]; + + // currently, all grid points are type 1 + + const int itype = 1; + int ielem = 0; + if (chemflag) + ielem = map[itype]; + const double radi = radelem[itype]; + + // rij[][3] = displacements between atom I and those neighbors + // inside = indices of neighbors of I within cutoff + // typej = types of neighbors of I within cutoff + + int ninside = 0; + for (int j = 0; j < ntotal; j++) { + + const double delx = xtmp - x[j][0]; + const double dely = ytmp - x[j][1]; + const double delz = ztmp - x[j][2]; + const double rsq = delx*delx + dely*dely + delz*delz; + int jtype = type[j]; + int jelem = 0; + if (chemflag) + jelem = map[jtype]; + if (rsq < cutsq[jtype][jtype] && rsq > 1e-20) { + snaptr->rij[ninside][0] = delx; + snaptr->rij[ninside][1] = dely; + snaptr->rij[ninside][2] = delz; + snaptr->inside[ninside] = j; + snaptr->wj[ninside] = wjelem[jtype]; + snaptr->rcutij[ninside] = 2.0*radelem[jtype]*rcutfac; + snaptr->element[ninside] = jelem; // element index for multi-element snap + ninside++; + } + } + + snaptr->compute_ui(ninside, ielem); + snaptr->compute_zi(); + snaptr->compute_bi(ielem); + + // linear contributions + + for (int icoeff = 0; icoeff < ncoeff; icoeff++) + gridlocal[ndesc_base+icoeff][iz][iy][ix] = + snaptr->blist[icoeff]; + + // quadratic contributions + + if (quadraticflag) { + int ncount = ncoeff; + for (int icoeff = 0; icoeff < ncoeff; icoeff++) { + double bveci = snaptr->blist[icoeff]; + gridlocal[ndesc_base+ncount++][iz][iy][ix] = + 0.5*bveci*bveci; + for (int jcoeff = icoeff+1; jcoeff < ncoeff; jcoeff++) + gridlocal[ndesc_base+ncount++][iz][iy][ix] = + bveci*snaptr->blist[jcoeff]; + } + } + } +} + + +/* ---------------------------------------------------------------------- + memory usage +------------------------------------------------------------------------- */ + +double PairSNAGrid::memory_usage() +{ + double nbytes = snaptr->memory_usage(); // SNA object + int n = atom->ntypes+1; + nbytes += (double)n*sizeof(int); // map + + return nbytes; +} + diff --git a/src/ML-SNAP/pair_sna_grid.h b/src/ML-SNAP/pair_sna_grid.h new file mode 100644 index 0000000000..d94032e58c --- /dev/null +++ b/src/ML-SNAP/pair_sna_grid.h @@ -0,0 +1,76 @@ +/* -*- c++ -*- ---------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + https://www.lammps.org/, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#ifdef PAIR_CLASS +// clang-format off +PairStyle(sna/grid, PairSNAGrid); +// clang-format on +#else + +#ifndef LMP_PAIR_SNA_GRID_H +#define LMP_PAIR_SNA_GRID_H + +#include "pair_grid.h" + +namespace LAMMPS_NS { + +class PairSNAGrid : public PairGrid { + public: + PairSNAGrid(class LAMMPS *); + ~PairSNAGrid(); + + void init(); + void init_list(int, class NeighList *); + void compute(int, int); + double memory_usage(); + + private: + int ncoeff; + double **cutsq; + class NeighList *list; + double rcutfac; + double *radelem; + double *wjelem; + int *map; // map types to [0,nelements) + int nelements, chemflag; + class SNA *snaptr; + double cutmax; + int quadraticflag; +}; + +} + +#endif +#endif + +/* ERROR/WARNING messages: + +E: Illegal ... command + +Self-explanatory. Check the input script syntax and compare to the +documentation for the command. You can use -echo screen as a +command-line option when running LAMMPS to see the offending line. + +E: Compute sna/grid/local requires a pair style be defined + +Self-explanatory. + +E: Compute sna/grid/local cutoff is longer than pairwise cutoff + +Self-explanatory. + +W: More than one compute sna/grid/local + +Self-explanatory. + +*/ diff --git a/src/pair_grid.cpp b/src/pair_grid.cpp new file mode 100644 index 0000000000..2d4abb7388 --- /dev/null +++ b/src/pair_grid.cpp @@ -0,0 +1,344 @@ +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#include "pair_grid.h" +#include +#include +#include "atom.h" +#include "update.h" +#include "modify.h" +#include "domain.h" +#include "force.h" +#include "memory.h" +#include "error.h" +#include "comm.h" + +using namespace LAMMPS_NS; + +/* ---------------------------------------------------------------------- */ + +PairGrid::PairGrid(LAMMPS *lmp) : + Pair(lmp), gridlocal(nullptr), alocal(nullptr) +{ + single_enable = 0; + restartinfo = 0; + one_coeff = 1; + manybody_flag = 1; + centroidstressflag = CENTROID_NOTAVAIL; + + + ndesc = 0; + ngridlocal = 0; + + ndesc_base = 6; + gridlocal_allocated = 0; + beta_max = 0; + beta = nullptr; +} + +/* ---------------------------------------------------------------------- */ + +PairGrid::~PairGrid() +{ + if (copymode) return; + + memory->destroy(beta); + + deallocate_grid(); +} + +/* ---------------------------------------------------------------------- */ + +void PairGrid::init() +{ +} + +/* ---------------------------------------------------------------------- */ + +void PairGrid::setup() +{ + deallocate_grid(); + set_grid_global(); + set_grid_local(); + allocate_grid(); + assign_coords(); +} + +/* ---------------------------------------------------------------------- + convert global array indexes to box coords +------------------------------------------------------------------------- */ + +void PairGrid::grid2x(int ix, int iy, int iz, double *x) +{ + x[0] = ix*delx; + x[1] = iy*dely; + x[2] = iz*delz; + + if (triclinic) domain->lamda2x(x, x); +} + +/* ---------------------------------------------------------------------- + create arrays +------------------------------------------------------------------------- */ + +void PairGrid::allocate_grid() +{ + if (nxlo <= nxhi && nylo <= nyhi && nzlo <= nzhi) { + gridlocal_allocated = 1; + memory->create4d_offset(gridlocal,ndesc,nzlo,nzhi,nylo,nyhi, + nxlo,nxhi,"pair/grid:gridlocal"); + memory->create(alocal, ngridlocal, ndesc, "pair/grid:alocal"); + } +} + +/* ---------------------------------------------------------------------- + free arrays +------------------------------------------------------------------------- */ + +void PairGrid::deallocate_grid() +{ + if (gridlocal_allocated) { + gridlocal_allocated = 0; + memory->destroy4d_offset(gridlocal,nzlo,nylo,nxlo); + memory->destroy(alocal); + } +} + +/* ---------------------------------------------------------------------- + set global grid +------------------------------------------------------------------------- */ + +void PairGrid::set_grid_global() +{ + // calculate grid layout + + triclinic = domain->triclinic; + + if (triclinic == 0) { + prd = domain->prd; + boxlo = domain->boxlo; + sublo = domain->sublo; + subhi = domain->subhi; + } else { + prd = domain->prd_lamda; + boxlo = domain->boxlo_lamda; + sublo = domain->sublo_lamda; + subhi = domain->subhi_lamda; + } + + double xprd = prd[0]; + double yprd = prd[1]; + double zprd = prd[2]; + + delxinv = nx/xprd; + delyinv = ny/yprd; + delzinv = nz/zprd; + + delx = 1.0/delxinv; + dely = 1.0/delyinv; + delz = 1.0/delzinv; +} + +/* ---------------------------------------------------------------------- + set local subset of grid that I own + n xyz lo/hi = 3d brick that I own (inclusive) +------------------------------------------------------------------------- */ + +void PairGrid::set_grid_local() +{ + // nx,ny,nz = extent of global grid + // indices into the global grid range from 0 to N-1 in each dim + // if grid point is inside my sub-domain I own it, + // this includes sub-domain lo boundary but excludes hi boundary + // ixyz lo/hi = inclusive lo/hi bounds of global grid sub-brick I own + // if proc owns no grid cells in a dim, then ilo > ihi + // if 2 procs share a boundary a grid point is exactly on, + // the 2 equality if tests insure a consistent decision + // as to which proc owns it + + double xfraclo,xfrachi,yfraclo,yfrachi,zfraclo,zfrachi; + + if (comm->layout != Comm::LAYOUT_TILED) { + xfraclo = comm->xsplit[comm->myloc[0]]; + xfrachi = comm->xsplit[comm->myloc[0]+1]; + yfraclo = comm->ysplit[comm->myloc[1]]; + yfrachi = comm->ysplit[comm->myloc[1]+1]; + zfraclo = comm->zsplit[comm->myloc[2]]; + zfrachi = comm->zsplit[comm->myloc[2]+1]; + } else { + xfraclo = comm->mysplit[0][0]; + xfrachi = comm->mysplit[0][1]; + yfraclo = comm->mysplit[1][0]; + yfrachi = comm->mysplit[1][1]; + zfraclo = comm->mysplit[2][0]; + zfrachi = comm->mysplit[2][1]; + } + + nxlo = static_cast (xfraclo * nx); + if (1.0*nxlo != xfraclo*nx) nxlo++; + nxhi = static_cast (xfrachi * nx); + if (1.0*nxhi == xfrachi*nx) nxhi--; + + nylo = static_cast (yfraclo * ny); + if (1.0*nylo != yfraclo*ny) nylo++; + nyhi = static_cast (yfrachi * ny); + if (1.0*nyhi == yfrachi*ny) nyhi--; + + nzlo = static_cast (zfraclo * nz); + if (1.0*nzlo != zfraclo*nz) nzlo++; + nzhi = static_cast (zfrachi * nz); + if (1.0*nzhi == zfrachi*nz) nzhi--; + + ngridlocal = (nxhi - nxlo + 1) * (nyhi - nylo + 1) * (nzhi - nzlo + 1); +} + +/* ---------------------------------------------------------------------- + copy coords to local array +------------------------------------------------------------------------- */ + +void PairGrid::assign_coords() +{ + int igrid = 0; + for (int iz = nzlo; iz <= nzhi; iz++) + for (int iy = nylo; iy <= nyhi; iy++) + for (int ix = nxlo; ix <= nxhi; ix++) { + alocal[igrid][0] = ix; + alocal[igrid][1] = iy; + alocal[igrid][2] = iz; + double xgrid[3]; + grid2x(ix, iy, iz, xgrid); + alocal[igrid][3] = xgrid[0]; + alocal[igrid][4] = xgrid[1]; + alocal[igrid][5] = xgrid[2]; + igrid++; + } +} + +/* ---------------------------------------------------------------------- + copy the 4d gridlocal array values to the 2d local array +------------------------------------------------------------------------- */ + +void PairGrid::copy_gridlocal_to_local_array() +{ + int igrid = 0; + for (int iz = nzlo; iz <= nzhi; iz++) + for (int iy = nylo; iy <= nyhi; iy++) + for (int ix = nxlo; ix <= nxhi; ix++) { + for (int icol = ndesc_base; icol < ndesc; icol++) + alocal[igrid][icol] = gridlocal[icol][iz][iy][ix]; + igrid++; + } +} + +/* ---------------------------------------------------------------------- + get beta from someplace +------------------------------------------------------------------------- */ + +void PairGrid::compute_beta() +{ + int igrid = 0; + for (int iz = nzlo; iz <= nzhi; iz++) + for (int iy = nylo; iy <= nyhi; iy++) + for (int ix = nxlo; ix <= nxhi; ix++) { + for (int icol = ndesc_base; icol < ndesc; icol++) + beta[igrid][icol] = 1.0; + igrid++; + } +} + +/* ---------------------------------------------------------------------- + allocate all arrays +------------------------------------------------------------------------- */ + +void PairGrid::allocate() +{ + allocated = 1; + int n = atom->ntypes; + memory->create(setflag,n+1,n+1,"pair:setflag"); + memory->create(cutsq,n+1,n+1,"pair:cutsq"); + map = new int[n+1]; +} + +/* ---------------------------------------------------------------------- + global settings +------------------------------------------------------------------------- */ + +void PairGrid::settings(int narg, char ** arg) +{ + if (narg < 6) error->all(FLERR,"Illegal pair style command"); + + int iarg0 = 3; + int iarg = iarg0; + if (strcmp(arg[iarg],"grid") == 0) { + if (iarg+4 > narg) error->all(FLERR,"Illegal pair grid command"); + nx = utils::inumeric(FLERR,arg[iarg+1],false,lmp); + ny = utils::inumeric(FLERR,arg[iarg+2],false,lmp); + nz = utils::inumeric(FLERR,arg[iarg+3],false,lmp); + if (nx <= 0 || ny <= 0 || nz <= 0) + error->all(FLERR,"All grid/local dimensions must be positive"); + iarg += 4; + } else error->all(FLERR,"Illegal pair grid command"); + + nargbase = iarg - iarg0; + +} + +/* ---------------------------------------------------------------------- + set coeffs for one or more type pairs +------------------------------------------------------------------------- */ + +void PairGrid::coeff(int narg, char **arg) +{ + if (!allocated) allocate(); + if (narg != 2 + atom->ntypes) error->all(FLERR,"Incorrect args for pair coefficients"); + + map_element2type(narg-4,arg+4); + +} + +/* ---------------------------------------------------------------------- + init specific to this pair style +------------------------------------------------------------------------- */ + +void PairGrid::init_style() +{ + if (force->newton_pair == 0) + error->all(FLERR,"Pair style grid requires newton pair on"); + + // no neighbor list + + // int irequest = neighbor->request(this,instance_me); + // neighbor->requests[irequest]->half = 0; + // neighbor->requests[irequest]->full = 1; + +} + +/* ---------------------------------------------------------------------- + init for one type pair i,j and corresponding j,i +------------------------------------------------------------------------- */ + +double PairGrid::init_one(int i, int j) +{ + if (setflag[i][j] == 0) error->all(FLERR,"All pair coeffs are not set"); + return 0.0; +} + +/* ---------------------------------------------------------------------- + memory usage of local data +------------------------------------------------------------------------- */ + +double PairGrid::memory_usage() +{ + int nbytes = ndesc*ngridlocal*sizeof(double); // gridlocal + return nbytes; +} diff --git a/src/pair_grid.h b/src/pair_grid.h new file mode 100644 index 0000000000..9c40165154 --- /dev/null +++ b/src/pair_grid.h @@ -0,0 +1,88 @@ +/* -*- c++ -*- ---------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#ifdef PAIR_CLASS +// clang-format off +PairStyle(grid,PairGrid); +// clang-format on +#else + +#ifndef LMP_PAIR_GRID_H +#define LMP_PAIR_GRID_H + +#include "pair.h" + +namespace LAMMPS_NS { + +class PairGrid : public Pair { + public: + PairGrid(class LAMMPS *); + virtual ~PairGrid(); + void init(); + void setup(); + virtual void compute(int, int) { + printf("DANGER! This function should always be overridden by child\n"); + }; + + void settings(int, char **); + virtual void coeff(int, char **); + virtual void init_style(); + virtual double init_one(int, int); + double memory_usage(); + + protected: + int nx, ny, nz; // global grid dimensions + int nxlo, nxhi, nylo, nyhi, nzlo, nzhi; // local grid bounds, inclusive + int ngridlocal; // number of local grid points + int nvalues; // number of values per grid point + double ****gridlocal; // local grid + double **alocal; // pointer to Compute::array_local + int triclinic; // triclinic flag + double *boxlo, *prd; // box info (units real/ortho or reduced/tri) + double *sublo, *subhi; // subdomain info (units real/ortho or reduced/tri) + double delxinv,delyinv,delzinv; // inverse grid spacing + double delx,dely,delz; // grid spacing + int nargbase; // number of base class args + double cutmax; // largest cutoff distance + int ndesc; // number of descriptors + int ndesc_base; // number of columns used for coords, etc. + int gridlocal_allocated; // shows if gridlocal allocated + double **beta; // betas for all local grid points in list + int beta_max; // length of beta + + void allocate(); // allocate pairstyle arrays + void allocate_grid(); // create grid arrays + void deallocate_grid(); // free grid arrays + void grid2x(int, int, int, double*); // convert global indices to coordinates + void set_grid_global(); // set global grid + void set_grid_local(); // set bounds for local grid + void assign_coords(); // assign coords for grid + void copy_gridlocal_to_local_array();// copy 4d gridlocal array to 2d local array + void compute_beta(); // get betas from someplace + private: +}; + +} + +#endif +#endif + +/* ERROR/WARNING messages: + +E: Illegal ... command + +Self-explanatory. Check the input script syntax and compare to the +documentation for the command. You can use -echo screen as a +command-line option when running LAMMPS to see the offending line. + +*/ From f41d65029418633e688bcb24e1f1b83414f1ba75 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Sun, 3 Oct 2021 17:59:33 -0600 Subject: [PATCH 044/585] Added non-working pair script --- examples/snap/in.grid.pair | 61 ++++++++++++++++++++++++++++++++++++++ 1 file changed, 61 insertions(+) create mode 100644 examples/snap/in.grid.pair diff --git a/examples/snap/in.grid.pair b/examples/snap/in.grid.pair new file mode 100644 index 0000000000..ee40984ce6 --- /dev/null +++ b/examples/snap/in.grid.pair @@ -0,0 +1,61 @@ +# Demonstrate bispectrum computes + +# CORRECTNESS: thermo output for c_mygrid[*][1] and c_mygrid[*][8] should +# match the values in dump_b: 108.173 3.21778 0.712238 7.06634 1.04273 + +# Initialize simulation + +variable nsteps index 0 +variable nrep index 3 +variable a index 3.316 +variable ngrid index 2 + +units metal + +atom_modify map yes + +# generate the box and atom positions using a BCC lattice + +variable nx equal ${nrep} +variable ny equal ${nrep} +variable nz equal ${nrep} + +boundary p p p + +lattice custom $a & + a1 1 0 0 & + a2 0 1 0 & + a3 0 0 1 & + basis 0 0 0 & + basis 0.5 0.5 0.5 & +# origin 0.25 0.25 0.25 +# origin 0.25e-3 0.25e-3 0.25e-3 + +region box block 0 ${nx} 0 ${ny} 0 ${nz} +create_box 1 box +create_atoms 1 box + +mass 1 180.88 + +write_dump all custom test.dump id type x y z + +# define grid compute and atom compute + +group snapgroup type 1 +variable twojmax equal 2 +variable rcutfac equal 4.67637 +variable rfac0 equal 0.99363 +variable rmin0 equal 0 +variable wj equal 1 +variable radelem equal 0.5 +variable bzero equal 0 +variable quad equal 0 +variable switch equal 1 + +pair_style sna/grid grid ${ngrid} ${ngrid} ${ngrid} & + ${rcutfac} ${rfac0} ${twojmax} ${radelem} & + ${wj} rmin0 ${rmin0} bzeroflag ${bzero} & + quadraticflag ${quad} switchflag ${switch} +pair_coeff * * + +run 0 From e698d295fc6fd6afdeca34ee2709342b1427f6d7 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Sun, 3 Oct 2021 18:35:54 -0600 Subject: [PATCH 045/585] Fixed some parsing errors, more waiting --- src/ML-SNAP/pair_sna_grid.cpp | 120 ++++++++++++++++++++++++++++++++++ src/ML-SNAP/pair_sna_grid.h | 1 + src/pair_grid.cpp | 7 +- 3 files changed, 123 insertions(+), 5 deletions(-) diff --git a/src/ML-SNAP/pair_sna_grid.cpp b/src/ML-SNAP/pair_sna_grid.cpp index 605e05ebf9..f2176b7520 100644 --- a/src/ML-SNAP/pair_sna_grid.cpp +++ b/src/ML-SNAP/pair_sna_grid.cpp @@ -167,6 +167,126 @@ void PairSNAGrid::compute(int eflag, int vflag) } +/* ---------------------------------------------------------------------- + global settings +------------------------------------------------------------------------- */ + +void PairSNAGrid::settings(int narg, char ** arg) +{ + double rfac0, rmin0; + int twojmax, switchflag, bzeroflag, bnormflag, wselfallflag; + + // call base class first + + PairGrid::settings(narg, arg); + + // skip over arguments used by base class + // so that argument positions are identical to + // regular per-atom compute + + arg += nargbase; + narg -= nargbase; + + int ntypes = atom->ntypes; + int nargmin = 3+2*ntypes; + + if (narg < nargmin) error->all(FLERR,"Illegal pair sna/grid command"); + + // default values + + rmin0 = 0.0; + switchflag = 1; + bzeroflag = 1; + quadraticflag = 0; + chemflag = 0; + bnormflag = 0; + wselfallflag = 0; + nelements = 1; + + // process required arguments + + memory->create(radelem,ntypes+1,"sna/grid/local:radelem"); // offset by 1 to match up with types + memory->create(wjelem,ntypes+1,"sna/grid/local:wjelem"); + + rcutfac = atof(arg[0]); + rfac0 = atof(arg[1]); + twojmax = atoi(arg[2]); + + for(int i = 0; i < ntypes; i++) + radelem[i+1] = atof(arg[3+i]); + for(int i = 0; i < ntypes; i++) + wjelem[i+1] = atof(arg[3+ntypes+i]); + + // construct cutsq + + double cut; + cutmax = 0.0; + memory->create(cutsq,ntypes+1,ntypes+1,"sna/grid/local:cutsq"); + for(int i = 1; i <= ntypes; i++) { + cut = 2.0*radelem[i]*rcutfac; + if (cut > cutmax) cutmax = cut; + cutsq[i][i] = cut*cut; + for(int j = i+1; j <= ntypes; j++) { + cut = (radelem[i]+radelem[j])*rcutfac; + cutsq[i][j] = cutsq[j][i] = cut*cut; + } + } + + // process optional args + + int iarg = nargmin; + + while (iarg < narg) { + printf("%d %d %d %s\n",iarg,narg,nargbase,arg[iarg]); + if (strcmp(arg[iarg],"rmin0") == 0) { + if (iarg+2 > narg) + error->all(FLERR,"Illegal pair sna/grid command"); + rmin0 = atof(arg[iarg+1]); + iarg += 2; + } else if (strcmp(arg[iarg],"switchflag") == 0) { + if (iarg+2 > narg) + error->all(FLERR,"Illegal pair sna/grid command"); + switchflag = atoi(arg[iarg+1]); + iarg += 2; + } else if (strcmp(arg[iarg],"bzeroflag") == 0) { + if (iarg+2 > narg) + error->all(FLERR,"Illegal pair sna/grid command"); + bzeroflag = atoi(arg[iarg+1]); + iarg += 2; + } else if (strcmp(arg[iarg],"quadraticflag") == 0) { + if (iarg+2 > narg) + error->all(FLERR,"Illegal pair sna/grid command"); + quadraticflag = atoi(arg[iarg+1]); + iarg += 2; + } else if (strcmp(arg[iarg],"chem") == 0) { + if (iarg+2 > narg) + error->all(FLERR,"Illegal pair sna/grid command"); + chemflag = 1; + memory->create(map,ntypes+1,"compute_sna_grid_local:map"); + nelements = utils::inumeric(FLERR,arg[iarg+1],false,lmp); + for (int i = 0; i < ntypes; i++) { + int jelem = utils::inumeric(FLERR,arg[iarg+2+i],false,lmp); + if (jelem < 0 || jelem >= nelements) + error->all(FLERR,"Illegal pair sna/grid command"); + map[i+1] = jelem; + } + iarg += 2+ntypes; + } else if (strcmp(arg[iarg],"bnormflag") == 0) { + if (iarg+2 > narg) + error->all(FLERR,"Illegal pair sna/grid command"); + bnormflag = atoi(arg[iarg+1]); + iarg += 2; + } else if (strcmp(arg[iarg],"wselfallflag") == 0) { + if (iarg+2 > narg) + error->all(FLERR,"Illegal pair sna/grid command"); + wselfallflag = atoi(arg[iarg+1]); + iarg += 2; + } else error->all(FLERR,"Illegal pair sna/grid command"); + + } + +} + /* ---------------------------------------------------------------------- memory usage ------------------------------------------------------------------------- */ diff --git a/src/ML-SNAP/pair_sna_grid.h b/src/ML-SNAP/pair_sna_grid.h index d94032e58c..30b6aa8f92 100644 --- a/src/ML-SNAP/pair_sna_grid.h +++ b/src/ML-SNAP/pair_sna_grid.h @@ -31,6 +31,7 @@ class PairSNAGrid : public PairGrid { void init(); void init_list(int, class NeighList *); + void settings(int, char **); void compute(int, int); double memory_usage(); diff --git a/src/pair_grid.cpp b/src/pair_grid.cpp index 2d4abb7388..56478ad21f 100644 --- a/src/pair_grid.cpp +++ b/src/pair_grid.cpp @@ -275,9 +275,8 @@ void PairGrid::allocate() void PairGrid::settings(int narg, char ** arg) { - if (narg < 6) error->all(FLERR,"Illegal pair style command"); - - int iarg0 = 3; + if (narg < 4) error->all(FLERR,"Illegal pair style command"); + int iarg0 = 0; int iarg = iarg0; if (strcmp(arg[iarg],"grid") == 0) { if (iarg+4 > narg) error->all(FLERR,"Illegal pair grid command"); @@ -288,9 +287,7 @@ void PairGrid::settings(int narg, char ** arg) error->all(FLERR,"All grid/local dimensions must be positive"); iarg += 4; } else error->all(FLERR,"Illegal pair grid command"); - nargbase = iarg - iarg0; - } /* ---------------------------------------------------------------------- From a2f62ae2dbb609fc7d768421113cb697c1d75ac9 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Tue, 19 Oct 2021 16:10:51 -0600 Subject: [PATCH 046/585] angles issue with angle vs anglep --- src/AMOEBA/angle_amoeba.cpp | 19 ++++++------------- tools/tinker2lmp.py | 18 ------------------ 2 files changed, 6 insertions(+), 31 deletions(-) diff --git a/src/AMOEBA/angle_amoeba.cpp b/src/AMOEBA/angle_amoeba.cpp index 4476615a50..6faf2edbdd 100644 --- a/src/AMOEBA/angle_amoeba.cpp +++ b/src/AMOEBA/angle_amoeba.cpp @@ -79,6 +79,8 @@ void AngleAmoeba::compute(int eflag, int vflag) double **x = atom->x; double **f = atom->f; int **anglelist = neighbor->anglelist; + int **nspecial = atom->nspecial; + int nanglelist = neighbor->nanglelist; int nlocal = atom->nlocal; int newton_bond = force->newton_bond; @@ -90,11 +92,11 @@ void AngleAmoeba::compute(int eflag, int vflag) type = anglelist[n][3]; // tflag = 0 for "angle", 1 for "anglep" in Tinker PRM file - // atom 2 must have 3 bond partners to invoke "anglep" option + // atom 2 must have 3 bond partners to invoke anglep() variant tflag = pflag[type]; - if (tflag && atom->num_bond[i2] == 3) { + if (tflag && nspecial[i2][0] == 3) { anglep(i1,i2,i3,type,eflag); continue; } @@ -203,7 +205,7 @@ void AngleAmoeba::anglep(int i1, int i2, int i3, int type, int eflag) double **x = atom->x; double **f = atom->f; - tagint **bond_atom = atom->bond_atom; + tagint **special = atom->special; int nlocal = atom->nlocal; int newton_bond = force->newton_bond; @@ -213,7 +215,7 @@ void AngleAmoeba::anglep(int i1, int i2, int i3, int type, int eflag) i3tag = atom->tag[i3]; for (int ibond = 0; ibond < 3; ibond++) { - i4tag = bond_atom[i2][ibond]; + i4tag = special[i2][ibond]; if (i4tag != i1tag && i4tag != i3tag) break; } @@ -290,15 +292,6 @@ void AngleAmoeba::anglep(int i1, int i2, int i3, int type, int eflag) if (eflag) eangle = k2[type]*dtheta2 + k3[type]*dtheta3 + k4[type]*dtheta4 + k5[type]*dtheta5 + k6[type]*dtheta6; - /* - printf("ANGLEP: %d %d %d %d: eng %g\n", - atom->tag[i1], - atom->tag[i2], - atom->tag[i3], - atom->tag[i4], - eangle); - */ - // chain rule terms for first derivative components terma = -deddt / (rap2*rm); diff --git a/tools/tinker2lmp.py b/tools/tinker2lmp.py index 9b4aec3a5f..4d272c3fa9 100644 --- a/tools/tinker2lmp.py +++ b/tools/tinker2lmp.py @@ -580,9 +580,6 @@ atype = [] aparams = [] baparams = [] -#DEBUG -opcount = 0 - for atom1,atom2,atom3 in alist: type1 = type[atom1-1] type2 = type[atom2-1] @@ -609,9 +606,6 @@ for atom1,atom2,atom3 in alist: # option 2 if one of 2 additional bonds is to an H atom # option 3 if both of 2 additional bonds is to an H atom - # DEBUG - debugflag = 0 - if len(params[3]) == 1: which = 1 @@ -638,10 +632,6 @@ for atom1,atom2,atom3 in alist: print " Nbonds and hydrogen count:",nbonds,hcount print " which:",which,m - # DEBUG - debugflag = 1 - opcount += 1 - elif len(params[3]) == 3: nbonds,hcount = xyz.angle_hbond_count(atom1,atom2,atom3,lmptype,lmpmass) @@ -668,24 +658,16 @@ for atom1,atom2,atom3 in alist: print " Nbonds and hydrogen count:",nbonds,hcount print " which:",which,m - # DEBUG - debugflag = 1 - opcount += 1 - else: print "Angle not found",atom1,atom2,atom3,c1,c2,c3 sys.exit() if not flags[m]: pflag,v1,v2,v3,v4,v5,v6 = params[3][which-1] - # DEBUG single line - if debugflag: pflag = 2 aparams.append((pflag,v1,v2,v3,v4,v5,v6)) flags[m] = len(aparams) atype.append(flags[m]) -print "OPTION angles",opcount - # NOTE: baparams may need to be flipped if match is 3,2,1 instead of 1,2,3 # NOTE: mismatch between angle and bondangle params may not be handled right From 657fcfa30df384e537c64100e5e882e110dfe15f Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Tue, 19 Oct 2021 17:29:53 -0600 Subject: [PATCH 047/585] added support for dihedral (torsion) calcs --- examples/amoeba/data.ubiquitin | 3518 +++++++++++++++++++++++++++++++- examples/amoeba/in.ubiquitin | 2 +- tools/tinker2lmp.py | 56 +- 3 files changed, 3538 insertions(+), 38 deletions(-) diff --git a/examples/amoeba/data.ubiquitin b/examples/amoeba/data.ubiquitin index d784798328..49dd8b1a70 100644 --- a/examples/amoeba/data.ubiquitin +++ b/examples/amoeba/data.ubiquitin @@ -3,9 +3,11 @@ LAMMPS data file created from Tinker ubiquitin2.xyz and amoeba_ubiquitin2.prm fi 9737 atoms 6908 bonds 5094 angles +3297 dihedrals 6 atom types 48 bond types 111 angle types +189 dihedral types 0 54.99 xlo xhi 0 41.91 ylo yhi 0 41.91 zlo zhi @@ -21767,6 +21769,3306 @@ Angles 5093 111 9733 9732 9734 5094 111 9736 9735 9737 +Dihedrals + +1 1 5 1 2 3 +2 2 5 1 2 8 +3 3 5 1 2 9 +4 1 6 1 2 3 +5 2 6 1 2 8 +6 3 6 1 2 9 +7 1 7 1 2 3 +8 2 7 1 2 8 +9 3 7 1 2 9 +10 4 1 2 3 4 +11 5 1 2 3 20 +12 6 1 2 9 10 +13 7 1 2 9 13 +14 7 1 2 9 14 +15 8 3 2 9 10 +16 9 3 2 9 13 +17 9 3 2 9 14 +18 10 8 2 3 4 +19 11 8 2 3 20 +20 12 8 2 9 10 +21 13 8 2 9 13 +22 13 8 2 9 14 +23 14 9 2 3 4 +24 15 9 2 3 20 +25 16 2 3 20 21 +26 17 2 3 20 24 +27 18 4 3 20 21 +28 19 4 3 20 24 +29 20 2 9 10 11 +30 21 2 9 10 15 +31 21 2 9 10 16 +32 22 13 9 10 11 +33 23 13 9 10 15 +34 23 13 9 10 16 +35 22 14 9 10 11 +36 23 14 9 10 15 +37 23 14 9 10 16 +38 24 9 10 11 12 +39 25 15 10 11 12 +40 25 16 10 11 12 +41 25 10 11 12 17 +42 25 10 11 12 18 +43 25 10 11 12 19 +44 26 3 20 21 22 +45 27 3 20 21 25 +46 28 3 20 21 26 +47 29 24 20 21 22 +48 30 24 20 21 25 +49 31 24 20 21 26 +50 32 20 21 22 23 +51 33 20 21 22 37 +52 34 20 21 26 27 +53 35 20 21 26 31 +54 35 20 21 26 32 +55 8 22 21 26 27 +56 9 22 21 26 31 +57 9 22 21 26 32 +58 10 25 21 22 23 +59 11 25 21 22 37 +60 12 25 21 26 27 +61 13 25 21 26 31 +62 13 25 21 26 32 +63 14 26 21 22 23 +64 15 26 21 22 37 +65 16 21 22 37 38 +66 17 21 22 37 41 +67 18 23 22 37 38 +68 19 23 22 37 41 +69 36 21 26 27 28 +70 21 21 26 27 33 +71 21 21 26 27 34 +72 37 31 26 27 28 +73 23 31 26 27 33 +74 23 31 26 27 34 +75 37 32 26 27 28 +76 23 32 26 27 33 +77 23 32 26 27 34 +78 38 26 27 28 29 +79 39 26 27 28 30 +80 40 33 27 28 29 +81 41 33 27 28 30 +82 40 34 27 28 29 +83 41 34 27 28 30 +84 42 27 28 30 35 +85 42 27 28 30 36 +86 19 29 28 30 35 +87 19 29 28 30 36 +88 26 22 37 38 39 +89 27 22 37 38 42 +90 43 22 37 38 43 +91 29 41 37 38 39 +92 30 41 37 38 42 +93 44 41 37 38 43 +94 32 37 38 39 40 +95 33 37 38 39 56 +96 45 37 38 43 44 +97 45 37 38 43 45 +98 46 37 38 43 47 +99 47 39 38 43 44 +100 47 39 38 43 45 +101 48 39 38 43 47 +102 10 42 38 39 40 +103 11 42 38 39 56 +104 49 42 38 43 44 +105 49 42 38 43 45 +106 50 42 38 43 47 +107 51 43 38 39 40 +108 52 43 38 39 56 +109 16 38 39 56 57 +110 17 38 39 56 60 +111 18 40 39 56 57 +112 19 40 39 56 60 +113 53 38 43 44 46 +114 54 38 43 44 48 +115 54 38 43 44 49 +116 54 38 43 45 50 +117 54 38 43 45 51 +118 54 38 43 45 52 +119 55 44 43 45 50 +120 55 44 43 45 51 +121 55 44 43 45 52 +122 56 45 43 44 46 +123 55 45 43 44 48 +124 55 45 43 44 49 +125 12 47 43 44 46 +126 13 47 43 44 48 +127 13 47 43 44 49 +128 13 47 43 45 50 +129 13 47 43 45 51 +130 13 47 43 45 52 +131 21 43 44 46 53 +132 21 43 44 46 54 +133 21 43 44 46 55 +134 23 48 44 46 53 +135 23 48 44 46 54 +136 23 48 44 46 55 +137 23 49 44 46 53 +138 23 49 44 46 54 +139 23 49 44 46 55 +140 26 39 56 57 58 +141 27 39 56 57 61 +142 28 39 56 57 62 +143 29 60 56 57 58 +144 30 60 56 57 61 +145 31 60 56 57 62 +146 32 56 57 58 59 +147 33 56 57 58 76 +148 57 56 57 62 63 +149 35 56 57 62 69 +150 35 56 57 62 70 +151 58 58 57 62 63 +152 9 58 57 62 69 +153 9 58 57 62 70 +154 10 61 57 58 59 +155 11 61 57 58 76 +156 59 61 57 62 63 +157 13 61 57 62 69 +158 13 61 57 62 70 +159 14 62 57 58 59 +160 15 62 57 58 76 +161 16 57 58 76 77 +162 17 57 58 76 80 +163 18 59 58 76 77 +164 19 59 58 76 80 +165 60 57 62 63 64 +166 60 57 62 63 65 +167 61 69 62 63 64 +168 61 69 62 63 65 +169 61 70 62 63 64 +170 61 70 62 63 65 +171 62 62 63 64 66 +172 63 62 63 64 71 +173 62 62 63 65 67 +174 63 62 63 65 72 +175 64 64 63 65 67 +176 65 64 63 65 72 +177 64 65 63 64 66 +178 65 65 63 64 71 +179 64 63 64 66 68 +180 65 63 64 66 73 +181 65 71 64 66 68 +182 66 71 64 66 73 +183 64 63 65 67 68 +184 65 63 65 67 74 +185 65 72 65 67 68 +186 66 72 65 67 74 +187 64 64 66 68 67 +188 65 64 66 68 75 +189 65 73 66 68 67 +190 66 73 66 68 75 +191 64 65 67 68 66 +192 65 65 67 68 75 +193 65 74 67 68 66 +194 66 74 67 68 75 +195 26 58 76 77 78 +196 27 58 76 77 81 +197 43 58 76 77 82 +198 29 80 76 77 78 +199 30 80 76 77 81 +200 44 80 76 77 82 +201 32 76 77 78 79 +202 33 76 77 78 92 +203 45 76 77 82 83 +204 45 76 77 82 84 +205 46 76 77 82 85 +206 47 78 77 82 83 +207 47 78 77 82 84 +208 48 78 77 82 85 +209 10 81 77 78 79 +210 11 81 77 78 92 +211 49 81 77 82 83 +212 49 81 77 82 84 +213 50 81 77 82 85 +214 51 82 77 78 79 +215 52 82 77 78 92 +216 16 77 78 92 93 +217 17 77 78 92 96 +218 18 79 78 92 93 +219 19 79 78 92 96 +220 54 77 82 83 86 +221 54 77 82 83 87 +222 54 77 82 83 88 +223 54 77 82 84 89 +224 54 77 82 84 90 +225 54 77 82 84 91 +226 55 83 82 84 89 +227 55 83 82 84 90 +228 55 83 82 84 91 +229 55 84 82 83 86 +230 55 84 82 83 87 +231 55 84 82 83 88 +232 13 85 82 83 86 +233 13 85 82 83 87 +234 13 85 82 83 88 +235 13 85 82 84 89 +236 13 85 82 84 90 +237 13 85 82 84 91 +238 26 78 92 93 94 +239 27 78 92 93 97 +240 28 78 92 93 98 +241 29 96 92 93 94 +242 30 96 92 93 97 +243 31 96 92 93 98 +244 32 92 93 94 95 +245 33 92 93 94 114 +246 34 92 93 98 99 +247 35 92 93 98 103 +248 35 92 93 98 104 +249 8 94 93 98 99 +250 9 94 93 98 103 +251 9 94 93 98 104 +252 10 97 93 94 95 +253 11 97 93 94 114 +254 12 97 93 98 99 +255 13 97 93 98 103 +256 13 97 93 98 104 +257 14 98 93 94 95 +258 15 98 93 94 114 +259 16 93 94 114 115 +260 17 93 94 114 118 +261 18 95 94 114 115 +262 19 95 94 114 118 +263 67 93 98 99 100 +264 21 93 98 99 105 +265 21 93 98 99 106 +266 68 103 98 99 100 +267 23 103 98 99 105 +268 23 103 98 99 106 +269 68 104 98 99 100 +270 23 104 98 99 105 +271 23 104 98 99 106 +272 69 98 99 100 101 +273 68 98 99 100 107 +274 68 98 99 100 108 +275 68 105 99 100 101 +276 23 105 99 100 107 +277 23 105 99 100 108 +278 68 106 99 100 101 +279 23 106 99 100 107 +280 23 106 99 100 108 +281 70 99 100 101 102 +282 68 99 100 101 109 +283 68 99 100 101 110 +284 71 107 100 101 102 +285 23 107 100 101 109 +286 23 107 100 101 110 +287 71 108 100 101 102 +288 23 108 100 101 109 +289 23 108 100 101 110 +290 72 100 101 102 111 +291 72 100 101 102 112 +292 72 100 101 102 113 +293 73 109 101 102 111 +294 73 109 101 102 112 +295 73 109 101 102 113 +296 73 110 101 102 111 +297 73 110 101 102 112 +298 73 110 101 102 113 +299 26 94 114 115 116 +300 27 94 114 115 119 +301 43 94 114 115 120 +302 29 118 114 115 116 +303 30 118 114 115 119 +304 44 118 114 115 120 +305 32 114 115 116 117 +306 33 114 115 116 128 +307 74 114 115 120 121 +308 45 114 115 120 122 +309 46 114 115 120 123 +310 75 116 115 120 121 +311 47 116 115 120 122 +312 48 116 115 120 123 +313 10 119 115 116 117 +314 11 119 115 116 128 +315 76 119 115 120 121 +316 49 119 115 120 122 +317 50 119 115 120 123 +318 51 120 115 116 117 +319 52 120 115 116 128 +320 16 115 116 128 129 +321 17 115 116 128 132 +322 18 117 116 128 129 +323 19 117 116 128 132 +324 77 115 120 121 124 +325 54 115 120 122 125 +326 54 115 120 122 126 +327 54 115 120 122 127 +328 78 121 120 122 125 +329 78 121 120 122 126 +330 78 121 120 122 127 +331 79 122 120 121 124 +332 80 123 120 121 124 +333 13 123 120 122 125 +334 13 123 120 122 126 +335 13 123 120 122 127 +336 26 116 128 129 130 +337 27 116 128 129 133 +338 28 116 128 129 134 +339 29 132 128 129 130 +340 30 132 128 129 133 +341 31 132 128 129 134 +342 32 128 129 130 131 +343 33 128 129 130 147 +344 81 128 129 134 135 +345 35 128 129 134 138 +346 35 128 129 134 139 +347 82 130 129 134 135 +348 9 130 129 134 138 +349 9 130 129 134 139 +350 10 133 129 130 131 +351 11 133 129 130 147 +352 83 133 129 134 135 +353 13 133 129 134 138 +354 13 133 129 134 139 +355 14 134 129 130 131 +356 15 134 129 130 147 +357 16 129 130 147 148 +358 17 129 130 147 151 +359 18 131 130 147 148 +360 19 131 130 147 151 +361 84 129 134 135 136 +362 84 129 134 135 137 +363 83 129 134 135 140 +364 55 138 134 135 136 +365 55 138 134 135 137 +366 13 138 134 135 140 +367 55 139 134 135 136 +368 55 139 134 135 137 +369 13 139 134 135 140 +370 55 134 135 136 141 +371 55 134 135 136 142 +372 55 134 135 136 143 +373 55 134 135 137 144 +374 55 134 135 137 145 +375 55 134 135 137 146 +376 55 136 135 137 144 +377 55 136 135 137 145 +378 55 136 135 137 146 +379 55 137 135 136 141 +380 55 137 135 136 142 +381 55 137 135 136 143 +382 13 140 135 136 141 +383 13 140 135 136 142 +384 13 140 135 136 143 +385 13 140 135 137 144 +386 13 140 135 137 145 +387 13 140 135 137 146 +388 26 130 147 148 149 +389 27 130 147 148 152 +390 43 130 147 148 153 +391 29 151 147 148 149 +392 30 151 147 148 152 +393 44 151 147 148 153 +394 32 147 148 149 150 +395 33 147 148 149 161 +396 74 147 148 153 154 +397 45 147 148 153 155 +398 46 147 148 153 156 +399 75 149 148 153 154 +400 47 149 148 153 155 +401 48 149 148 153 156 +402 10 152 148 149 150 +403 11 152 148 149 161 +404 76 152 148 153 154 +405 49 152 148 153 155 +406 50 152 148 153 156 +407 51 153 148 149 150 +408 52 153 148 149 161 +409 85 148 149 161 162 +410 17 148 149 161 165 +411 86 150 149 161 162 +412 19 150 149 161 165 +413 77 148 153 154 157 +414 54 148 153 155 158 +415 54 148 153 155 159 +416 54 148 153 155 160 +417 78 154 153 155 158 +418 78 154 153 155 159 +419 78 154 153 155 160 +420 79 155 153 154 157 +421 80 156 153 154 157 +422 13 156 153 155 158 +423 13 156 153 155 159 +424 13 156 153 155 160 +425 87 149 161 162 163 +426 88 149 161 162 166 +427 88 149 161 162 167 +428 89 165 161 162 163 +429 90 165 161 162 166 +430 90 165 161 162 167 +431 91 161 162 163 164 +432 92 161 162 163 168 +433 93 166 162 163 164 +434 94 166 162 163 168 +435 93 167 162 163 164 +436 94 167 162 163 168 +437 95 162 163 168 169 +438 96 162 163 168 172 +439 18 164 163 168 169 +440 19 164 163 168 172 +441 26 163 168 169 170 +442 27 163 168 169 173 +443 28 163 168 169 174 +444 29 172 168 169 170 +445 30 172 168 169 173 +446 31 172 168 169 174 +447 32 168 169 170 171 +448 33 168 169 170 190 +449 34 168 169 174 175 +450 35 168 169 174 179 +451 35 168 169 174 180 +452 8 170 169 174 175 +453 9 170 169 174 179 +454 9 170 169 174 180 +455 10 173 169 170 171 +456 11 173 169 170 190 +457 12 173 169 174 175 +458 13 173 169 174 179 +459 13 173 169 174 180 +460 14 174 169 170 171 +461 15 174 169 170 190 +462 16 169 170 190 191 +463 17 169 170 190 194 +464 18 171 170 190 191 +465 19 171 170 190 194 +466 67 169 174 175 176 +467 21 169 174 175 181 +468 21 169 174 175 182 +469 68 179 174 175 176 +470 23 179 174 175 181 +471 23 179 174 175 182 +472 68 180 174 175 176 +473 23 180 174 175 181 +474 23 180 174 175 182 +475 69 174 175 176 177 +476 68 174 175 176 183 +477 68 174 175 176 184 +478 68 181 175 176 177 +479 23 181 175 176 183 +480 23 181 175 176 184 +481 68 182 175 176 177 +482 23 182 175 176 183 +483 23 182 175 176 184 +484 70 175 176 177 178 +485 68 175 176 177 185 +486 68 175 176 177 186 +487 71 183 176 177 178 +488 23 183 176 177 185 +489 23 183 176 177 186 +490 71 184 176 177 178 +491 23 184 176 177 185 +492 23 184 176 177 186 +493 72 176 177 178 187 +494 72 176 177 178 188 +495 72 176 177 178 189 +496 73 185 177 178 187 +497 73 185 177 178 188 +498 73 185 177 178 189 +499 73 186 177 178 187 +500 73 186 177 178 188 +501 73 186 177 178 189 +502 26 170 190 191 192 +503 27 170 190 191 195 +504 43 170 190 191 196 +505 29 194 190 191 192 +506 30 194 190 191 195 +507 44 194 190 191 196 +508 32 190 191 192 193 +509 33 190 191 192 204 +510 74 190 191 196 197 +511 45 190 191 196 198 +512 46 190 191 196 199 +513 75 192 191 196 197 +514 47 192 191 196 198 +515 48 192 191 196 199 +516 10 195 191 192 193 +517 11 195 191 192 204 +518 76 195 191 196 197 +519 49 195 191 196 198 +520 50 195 191 196 199 +521 51 196 191 192 193 +522 52 196 191 192 204 +523 16 191 192 204 205 +524 17 191 192 204 208 +525 18 193 192 204 205 +526 19 193 192 204 208 +527 77 191 196 197 200 +528 54 191 196 198 201 +529 54 191 196 198 202 +530 54 191 196 198 203 +531 78 197 196 198 201 +532 78 197 196 198 202 +533 78 197 196 198 203 +534 79 198 196 197 200 +535 80 199 196 197 200 +536 13 199 196 198 201 +537 13 199 196 198 202 +538 13 199 196 198 203 +539 26 192 204 205 206 +540 27 192 204 205 209 +541 43 192 204 205 210 +542 29 208 204 205 206 +543 30 208 204 205 209 +544 44 208 204 205 210 +545 32 204 205 206 207 +546 33 204 205 206 223 +547 45 204 205 210 211 +548 45 204 205 210 212 +549 46 204 205 210 214 +550 47 206 205 210 211 +551 47 206 205 210 212 +552 48 206 205 210 214 +553 10 209 205 206 207 +554 11 209 205 206 223 +555 49 209 205 210 211 +556 49 209 205 210 212 +557 50 209 205 210 214 +558 51 210 205 206 207 +559 52 210 205 206 223 +560 16 205 206 223 224 +561 17 205 206 223 227 +562 18 207 206 223 224 +563 19 207 206 223 227 +564 53 205 210 211 213 +565 54 205 210 211 215 +566 54 205 210 211 216 +567 54 205 210 212 217 +568 54 205 210 212 218 +569 54 205 210 212 219 +570 55 211 210 212 217 +571 55 211 210 212 218 +572 55 211 210 212 219 +573 56 212 210 211 213 +574 55 212 210 211 215 +575 55 212 210 211 216 +576 12 214 210 211 213 +577 13 214 210 211 215 +578 13 214 210 211 216 +579 13 214 210 212 217 +580 13 214 210 212 218 +581 13 214 210 212 219 +582 21 210 211 213 220 +583 21 210 211 213 221 +584 21 210 211 213 222 +585 23 215 211 213 220 +586 23 215 211 213 221 +587 23 215 211 213 222 +588 23 216 211 213 220 +589 23 216 211 213 221 +590 23 216 211 213 222 +591 26 206 223 224 225 +592 27 206 223 224 228 +593 43 206 223 224 229 +594 29 227 223 224 225 +595 30 227 223 224 228 +596 44 227 223 224 229 +597 32 223 224 225 226 +598 33 223 224 225 237 +599 74 223 224 229 230 +600 45 223 224 229 231 +601 46 223 224 229 232 +602 75 225 224 229 230 +603 47 225 224 229 231 +604 48 225 224 229 232 +605 10 228 224 225 226 +606 11 228 224 225 237 +607 76 228 224 229 230 +608 49 228 224 229 231 +609 50 228 224 229 232 +610 51 229 224 225 226 +611 52 229 224 225 237 +612 16 224 225 237 238 +613 17 224 225 237 241 +614 18 226 225 237 238 +615 19 226 225 237 241 +616 77 224 229 230 233 +617 54 224 229 231 234 +618 54 224 229 231 235 +619 54 224 229 231 236 +620 78 230 229 231 234 +621 78 230 229 231 235 +622 78 230 229 231 236 +623 79 231 229 230 233 +624 80 232 229 230 233 +625 13 232 229 231 234 +626 13 232 229 231 235 +627 13 232 229 231 236 +628 26 225 237 238 239 +629 27 225 237 238 242 +630 28 225 237 238 243 +631 29 241 237 238 239 +632 30 241 237 238 242 +633 31 241 237 238 243 +634 32 237 238 239 240 +635 33 237 238 239 256 +636 81 237 238 243 244 +637 35 237 238 243 247 +638 35 237 238 243 248 +639 82 239 238 243 244 +640 9 239 238 243 247 +641 9 239 238 243 248 +642 10 242 238 239 240 +643 11 242 238 239 256 +644 83 242 238 243 244 +645 13 242 238 243 247 +646 13 242 238 243 248 +647 14 243 238 239 240 +648 15 243 238 239 256 +649 16 238 239 256 257 +650 17 238 239 256 260 +651 18 240 239 256 257 +652 19 240 239 256 260 +653 84 238 243 244 245 +654 84 238 243 244 246 +655 83 238 243 244 249 +656 55 247 243 244 245 +657 55 247 243 244 246 +658 13 247 243 244 249 +659 55 248 243 244 245 +660 55 248 243 244 246 +661 13 248 243 244 249 +662 55 243 244 245 250 +663 55 243 244 245 251 +664 55 243 244 245 252 +665 55 243 244 246 253 +666 55 243 244 246 254 +667 55 243 244 246 255 +668 55 245 244 246 253 +669 55 245 244 246 254 +670 55 245 244 246 255 +671 55 246 244 245 250 +672 55 246 244 245 251 +673 55 246 244 245 252 +674 13 249 244 245 250 +675 13 249 244 245 251 +676 13 249 244 245 252 +677 13 249 244 246 253 +678 13 249 244 246 254 +679 13 249 244 246 255 +680 26 239 256 257 258 +681 27 239 256 257 261 +682 28 239 256 257 262 +683 29 260 256 257 258 +684 30 260 256 257 261 +685 31 260 256 257 262 +686 32 256 257 258 259 +687 33 256 257 258 271 +688 34 256 257 262 263 +689 35 256 257 262 267 +690 35 256 257 262 268 +691 8 258 257 262 263 +692 9 258 257 262 267 +693 9 258 257 262 268 +694 10 261 257 258 259 +695 11 261 257 258 271 +696 12 261 257 262 263 +697 13 261 257 262 267 +698 13 261 257 262 268 +699 14 262 257 258 259 +700 15 262 257 258 271 +701 16 257 258 271 272 +702 17 257 258 271 275 +703 18 259 258 271 272 +704 19 259 258 271 275 +705 97 257 262 263 264 +706 21 257 262 263 269 +707 21 257 262 263 270 +708 98 267 262 263 264 +709 23 267 262 263 269 +710 23 267 262 263 270 +711 98 268 262 263 264 +712 23 268 262 263 269 +713 23 268 262 263 270 +714 99 262 263 264 265 +715 99 262 263 264 266 +716 100 269 263 264 265 +717 100 269 263 264 266 +718 100 270 263 264 265 +719 100 270 263 264 266 +720 26 258 271 272 273 +721 27 258 271 272 276 +722 43 258 271 272 277 +723 29 275 271 272 273 +724 30 275 271 272 276 +725 44 275 271 272 277 +726 32 271 272 273 274 +727 33 271 272 273 287 +728 45 271 272 277 278 +729 45 271 272 277 279 +730 46 271 272 277 280 +731 47 273 272 277 278 +732 47 273 272 277 279 +733 48 273 272 277 280 +734 10 276 272 273 274 +735 11 276 272 273 287 +736 49 276 272 277 278 +737 49 276 272 277 279 +738 50 276 272 277 280 +739 51 277 272 273 274 +740 52 277 272 273 287 +741 16 272 273 287 288 +742 17 272 273 287 291 +743 18 274 273 287 288 +744 19 274 273 287 291 +745 54 272 277 278 281 +746 54 272 277 278 282 +747 54 272 277 278 283 +748 54 272 277 279 284 +749 54 272 277 279 285 +750 54 272 277 279 286 +751 55 278 277 279 284 +752 55 278 277 279 285 +753 55 278 277 279 286 +754 55 279 277 278 281 +755 55 279 277 278 282 +756 55 279 277 278 283 +757 13 280 277 278 281 +758 13 280 277 278 282 +759 13 280 277 278 283 +760 13 280 277 279 284 +761 13 280 277 279 285 +762 13 280 277 279 286 +763 26 273 287 288 289 +764 27 273 287 288 292 +765 28 273 287 288 293 +766 29 291 287 288 289 +767 30 291 287 288 292 +768 31 291 287 288 293 +769 32 287 288 289 290 +770 101 287 288 289 302 +771 34 287 288 293 294 +772 35 287 288 293 298 +773 35 287 288 293 299 +774 8 289 288 293 294 +775 9 289 288 293 298 +776 9 289 288 293 299 +777 10 292 288 289 290 +778 102 292 288 289 302 +779 12 292 288 293 294 +780 13 292 288 293 298 +781 13 292 288 293 299 +782 14 293 288 289 290 +783 103 293 288 289 302 +784 104 288 289 302 303 +785 105 288 289 302 309 +786 106 290 289 302 303 +787 107 290 289 302 309 +788 97 288 293 294 295 +789 21 288 293 294 300 +790 21 288 293 294 301 +791 98 298 293 294 295 +792 23 298 293 294 300 +793 23 298 293 294 301 +794 98 299 293 294 295 +795 23 299 293 294 300 +796 23 299 293 294 301 +797 99 293 294 295 296 +798 99 293 294 295 297 +799 100 300 294 295 296 +800 100 300 294 295 297 +801 100 301 294 295 296 +802 100 301 294 295 297 +803 108 289 302 303 304 +804 109 289 302 303 306 +805 110 289 302 303 307 +806 111 289 302 309 308 +807 112 289 302 309 314 +808 112 289 302 309 315 +809 113 303 302 309 308 +810 114 303 302 309 314 +811 114 303 302 309 315 +812 115 309 302 303 304 +813 116 309 302 303 306 +814 117 309 302 303 307 +815 118 302 303 304 305 +816 119 302 303 304 316 +817 120 302 303 307 308 +818 121 302 303 307 310 +819 121 302 303 307 311 +820 122 304 303 307 308 +821 123 304 303 307 310 +822 123 304 303 307 311 +823 10 306 303 304 305 +824 11 306 303 304 316 +825 124 306 303 307 308 +826 125 306 303 307 310 +827 125 306 303 307 311 +828 126 307 303 304 305 +829 127 307 303 304 316 +830 16 303 304 316 317 +831 17 303 304 316 320 +832 18 305 304 316 317 +833 19 305 304 316 320 +834 128 303 307 308 309 +835 129 303 307 308 312 +836 129 303 307 308 313 +837 130 310 307 308 309 +838 131 310 307 308 312 +839 131 310 307 308 313 +840 130 311 307 308 309 +841 131 311 307 308 312 +842 131 311 307 308 313 +843 132 307 308 309 302 +844 133 307 308 309 314 +845 133 307 308 309 315 +846 134 312 308 309 302 +847 135 312 308 309 314 +848 135 312 308 309 315 +849 134 313 308 309 302 +850 135 313 308 309 314 +851 135 313 308 309 315 +852 26 304 316 317 318 +853 27 304 316 317 321 +854 28 304 316 317 322 +855 29 320 316 317 318 +856 30 320 316 317 321 +857 31 320 316 317 322 +858 32 316 317 318 319 +859 33 316 317 318 327 +860 136 316 317 322 323 +861 35 316 317 322 324 +862 35 316 317 322 325 +863 137 318 317 322 323 +864 9 318 317 322 324 +865 9 318 317 322 325 +866 10 321 317 318 319 +867 11 321 317 318 327 +868 138 321 317 322 323 +869 13 321 317 322 324 +870 13 321 317 322 325 +871 14 322 317 318 319 +872 15 322 317 318 327 +873 16 317 318 327 328 +874 17 317 318 327 331 +875 18 319 318 327 328 +876 19 319 318 327 331 +877 139 317 322 323 326 +878 140 324 322 323 326 +879 140 325 322 323 326 +880 26 318 327 328 329 +881 27 318 327 328 332 +882 28 318 327 328 333 +883 29 331 327 328 329 +884 30 331 327 328 332 +885 31 331 327 328 333 +886 32 327 328 329 330 +887 33 327 328 329 339 +888 141 327 328 333 334 +889 35 327 328 333 337 +890 35 327 328 333 338 +891 142 329 328 333 334 +892 9 329 328 333 337 +893 9 329 328 333 338 +894 10 332 328 329 330 +895 11 332 328 329 339 +896 143 332 328 333 334 +897 13 332 328 333 337 +898 13 332 328 333 338 +899 14 333 328 329 330 +900 15 333 328 329 339 +901 16 328 329 339 340 +902 17 328 329 339 343 +903 18 330 329 339 340 +904 19 330 329 339 343 +905 144 328 333 334 335 +906 144 328 333 334 336 +907 100 337 333 334 335 +908 100 337 333 334 336 +909 100 338 333 334 335 +910 100 338 333 334 336 +911 26 329 339 340 341 +912 27 329 339 340 344 +913 43 329 339 340 345 +914 29 343 339 340 341 +915 30 343 339 340 344 +916 44 343 339 340 345 +917 32 339 340 341 342 +918 33 339 340 341 353 +919 74 339 340 345 346 +920 45 339 340 345 347 +921 46 339 340 345 348 +922 75 341 340 345 346 +923 47 341 340 345 347 +924 48 341 340 345 348 +925 10 344 340 341 342 +926 11 344 340 341 353 +927 76 344 340 345 346 +928 49 344 340 345 347 +929 50 344 340 345 348 +930 51 345 340 341 342 +931 52 345 340 341 353 +932 16 340 341 353 354 +933 17 340 341 353 357 +934 18 342 341 353 354 +935 19 342 341 353 357 +936 77 340 345 346 349 +937 54 340 345 347 350 +938 54 340 345 347 351 +939 54 340 345 347 352 +940 78 346 345 347 350 +941 78 346 345 347 351 +942 78 346 345 347 352 +943 79 347 345 346 349 +944 80 348 345 346 349 +945 13 348 345 347 350 +946 13 348 345 347 351 +947 13 348 345 347 352 +948 26 341 353 354 355 +949 27 341 353 354 358 +950 43 341 353 354 359 +951 29 357 353 354 355 +952 30 357 353 354 358 +953 44 357 353 354 359 +954 32 353 354 355 356 +955 33 353 354 355 372 +956 45 353 354 359 360 +957 45 353 354 359 361 +958 46 353 354 359 363 +959 47 355 354 359 360 +960 47 355 354 359 361 +961 48 355 354 359 363 +962 10 358 354 355 356 +963 11 358 354 355 372 +964 49 358 354 359 360 +965 49 358 354 359 361 +966 50 358 354 359 363 +967 51 359 354 355 356 +968 52 359 354 355 372 +969 16 354 355 372 373 +970 17 354 355 372 376 +971 18 356 355 372 373 +972 19 356 355 372 376 +973 53 354 359 360 362 +974 54 354 359 360 364 +975 54 354 359 360 365 +976 54 354 359 361 366 +977 54 354 359 361 367 +978 54 354 359 361 368 +979 55 360 359 361 366 +980 55 360 359 361 367 +981 55 360 359 361 368 +982 56 361 359 360 362 +983 55 361 359 360 364 +984 55 361 359 360 365 +985 12 363 359 360 362 +986 13 363 359 360 364 +987 13 363 359 360 365 +988 13 363 359 361 366 +989 13 363 359 361 367 +990 13 363 359 361 368 +991 21 359 360 362 369 +992 21 359 360 362 370 +993 21 359 360 362 371 +994 23 364 360 362 369 +995 23 364 360 362 370 +996 23 364 360 362 371 +997 23 365 360 362 369 +998 23 365 360 362 370 +999 23 365 360 362 371 +1000 26 355 372 373 374 +1001 27 355 372 373 377 +1002 28 355 372 373 378 +1003 29 376 372 373 374 +1004 30 376 372 373 377 +1005 31 376 372 373 378 +1006 32 372 373 374 375 +1007 33 372 373 374 387 +1008 34 372 373 378 379 +1009 35 372 373 378 383 +1010 35 372 373 378 384 +1011 8 374 373 378 379 +1012 9 374 373 378 383 +1013 9 374 373 378 384 +1014 10 377 373 374 375 +1015 11 377 373 374 387 +1016 12 377 373 378 379 +1017 13 377 373 378 383 +1018 13 377 373 378 384 +1019 14 378 373 374 375 +1020 15 378 373 374 387 +1021 16 373 374 387 388 +1022 17 373 374 387 391 +1023 18 375 374 387 388 +1024 19 375 374 387 391 +1025 97 373 378 379 380 +1026 21 373 378 379 385 +1027 21 373 378 379 386 +1028 98 383 378 379 380 +1029 23 383 378 379 385 +1030 23 383 378 379 386 +1031 98 384 378 379 380 +1032 23 384 378 379 385 +1033 23 384 378 379 386 +1034 99 378 379 380 381 +1035 99 378 379 380 382 +1036 100 385 379 380 381 +1037 100 385 379 380 382 +1038 100 386 379 380 381 +1039 100 386 379 380 382 +1040 26 374 387 388 389 +1041 27 374 387 388 392 +1042 28 374 387 388 393 +1043 29 391 387 388 389 +1044 30 391 387 388 392 +1045 31 391 387 388 393 +1046 32 387 388 389 390 +1047 33 387 388 389 401 +1048 145 387 388 393 394 +1049 35 387 388 393 397 +1050 35 387 388 393 398 +1051 146 389 388 393 394 +1052 9 389 388 393 397 +1053 9 389 388 393 398 +1054 10 392 388 389 390 +1055 11 392 388 389 401 +1056 147 392 388 393 394 +1057 13 392 388 393 397 +1058 13 392 388 393 398 +1059 14 393 388 389 390 +1060 15 393 388 389 401 +1061 16 388 389 401 402 +1062 17 388 389 401 405 +1063 18 390 389 401 402 +1064 19 390 389 401 405 +1065 148 388 393 394 395 +1066 149 388 393 394 396 +1067 40 397 393 394 395 +1068 41 397 393 394 396 +1069 40 398 393 394 395 +1070 41 398 393 394 396 +1071 42 393 394 396 399 +1072 42 393 394 396 400 +1073 19 395 394 396 399 +1074 19 395 394 396 400 +1075 26 389 401 402 403 +1076 27 389 401 402 406 +1077 43 389 401 402 407 +1078 29 405 401 402 403 +1079 30 405 401 402 406 +1080 44 405 401 402 407 +1081 32 401 402 403 404 +1082 33 401 402 403 417 +1083 45 401 402 407 408 +1084 45 401 402 407 409 +1085 46 401 402 407 410 +1086 47 403 402 407 408 +1087 47 403 402 407 409 +1088 48 403 402 407 410 +1089 10 406 402 403 404 +1090 11 406 402 403 417 +1091 49 406 402 407 408 +1092 49 406 402 407 409 +1093 50 406 402 407 410 +1094 51 407 402 403 404 +1095 52 407 402 403 417 +1096 16 402 403 417 418 +1097 17 402 403 417 421 +1098 18 404 403 417 418 +1099 19 404 403 417 421 +1100 54 402 407 408 411 +1101 54 402 407 408 412 +1102 54 402 407 408 413 +1103 54 402 407 409 414 +1104 54 402 407 409 415 +1105 54 402 407 409 416 +1106 55 408 407 409 414 +1107 55 408 407 409 415 +1108 55 408 407 409 416 +1109 55 409 407 408 411 +1110 55 409 407 408 412 +1111 55 409 407 408 413 +1112 13 410 407 408 411 +1113 13 410 407 408 412 +1114 13 410 407 408 413 +1115 13 410 407 409 414 +1116 13 410 407 409 415 +1117 13 410 407 409 416 +1118 26 403 417 418 419 +1119 27 403 417 418 422 +1120 28 403 417 418 423 +1121 29 421 417 418 419 +1122 30 421 417 418 422 +1123 31 421 417 418 423 +1124 32 417 418 419 420 +1125 33 417 418 419 439 +1126 34 417 418 423 424 +1127 35 417 418 423 428 +1128 35 417 418 423 429 +1129 8 419 418 423 424 +1130 9 419 418 423 428 +1131 9 419 418 423 429 +1132 10 422 418 419 420 +1133 11 422 418 419 439 +1134 12 422 418 423 424 +1135 13 422 418 423 428 +1136 13 422 418 423 429 +1137 14 423 418 419 420 +1138 15 423 418 419 439 +1139 16 418 419 439 440 +1140 17 418 419 439 443 +1141 18 420 419 439 440 +1142 19 420 419 439 443 +1143 67 418 423 424 425 +1144 21 418 423 424 430 +1145 21 418 423 424 431 +1146 68 428 423 424 425 +1147 23 428 423 424 430 +1148 23 428 423 424 431 +1149 68 429 423 424 425 +1150 23 429 423 424 430 +1151 23 429 423 424 431 +1152 69 423 424 425 426 +1153 68 423 424 425 432 +1154 68 423 424 425 433 +1155 68 430 424 425 426 +1156 23 430 424 425 432 +1157 23 430 424 425 433 +1158 68 431 424 425 426 +1159 23 431 424 425 432 +1160 23 431 424 425 433 +1161 70 424 425 426 427 +1162 68 424 425 426 434 +1163 68 424 425 426 435 +1164 71 432 425 426 427 +1165 23 432 425 426 434 +1166 23 432 425 426 435 +1167 71 433 425 426 427 +1168 23 433 425 426 434 +1169 23 433 425 426 435 +1170 72 425 426 427 436 +1171 72 425 426 427 437 +1172 72 425 426 427 438 +1173 73 434 426 427 436 +1174 73 434 426 427 437 +1175 73 434 426 427 438 +1176 73 435 426 427 436 +1177 73 435 426 427 437 +1178 73 435 426 427 438 +1179 26 419 439 440 441 +1180 27 419 439 440 444 +1181 28 419 439 440 445 +1182 29 443 439 440 441 +1183 30 443 439 440 444 +1184 31 443 439 440 445 +1185 32 439 440 441 442 +1186 33 439 440 441 449 +1187 35 439 440 445 446 +1188 35 439 440 445 447 +1189 35 439 440 445 448 +1190 9 441 440 445 446 +1191 9 441 440 445 447 +1192 9 441 440 445 448 +1193 10 444 440 441 442 +1194 11 444 440 441 449 +1195 13 444 440 445 446 +1196 13 444 440 445 447 +1197 13 444 440 445 448 +1198 14 445 440 441 442 +1199 15 445 440 441 449 +1200 16 440 441 449 450 +1201 17 440 441 449 453 +1202 18 442 441 449 450 +1203 19 442 441 449 453 +1204 26 441 449 450 451 +1205 27 441 449 450 454 +1206 28 441 449 450 455 +1207 29 453 449 450 451 +1208 30 453 449 450 454 +1209 31 453 449 450 455 +1210 32 449 450 451 452 +1211 33 449 450 451 471 +1212 34 449 450 455 456 +1213 35 449 450 455 460 +1214 35 449 450 455 461 +1215 8 451 450 455 456 +1216 9 451 450 455 460 +1217 9 451 450 455 461 +1218 10 454 450 451 452 +1219 11 454 450 451 471 +1220 12 454 450 455 456 +1221 13 454 450 455 460 +1222 13 454 450 455 461 +1223 14 455 450 451 452 +1224 15 455 450 451 471 +1225 16 450 451 471 472 +1226 17 450 451 471 475 +1227 18 452 451 471 472 +1228 19 452 451 471 475 +1229 67 450 455 456 457 +1230 21 450 455 456 462 +1231 21 450 455 456 463 +1232 68 460 455 456 457 +1233 23 460 455 456 462 +1234 23 460 455 456 463 +1235 68 461 455 456 457 +1236 23 461 455 456 462 +1237 23 461 455 456 463 +1238 69 455 456 457 458 +1239 68 455 456 457 464 +1240 68 455 456 457 465 +1241 68 462 456 457 458 +1242 23 462 456 457 464 +1243 23 462 456 457 465 +1244 68 463 456 457 458 +1245 23 463 456 457 464 +1246 23 463 456 457 465 +1247 70 456 457 458 459 +1248 68 456 457 458 466 +1249 68 456 457 458 467 +1250 71 464 457 458 459 +1251 23 464 457 458 466 +1252 23 464 457 458 467 +1253 71 465 457 458 459 +1254 23 465 457 458 466 +1255 23 465 457 458 467 +1256 72 457 458 459 468 +1257 72 457 458 459 469 +1258 72 457 458 459 470 +1259 73 466 458 459 468 +1260 73 466 458 459 469 +1261 73 466 458 459 470 +1262 73 467 458 459 468 +1263 73 467 458 459 469 +1264 73 467 458 459 470 +1265 26 451 471 472 473 +1266 27 451 471 472 476 +1267 43 451 471 472 477 +1268 29 475 471 472 473 +1269 30 475 471 472 476 +1270 44 475 471 472 477 +1271 32 471 472 473 474 +1272 33 471 472 473 490 +1273 45 471 472 477 478 +1274 45 471 472 477 479 +1275 46 471 472 477 481 +1276 47 473 472 477 478 +1277 47 473 472 477 479 +1278 48 473 472 477 481 +1279 10 476 472 473 474 +1280 11 476 472 473 490 +1281 49 476 472 477 478 +1282 49 476 472 477 479 +1283 50 476 472 477 481 +1284 51 477 472 473 474 +1285 52 477 472 473 490 +1286 16 472 473 490 491 +1287 17 472 473 490 494 +1288 18 474 473 490 491 +1289 19 474 473 490 494 +1290 53 472 477 478 480 +1291 54 472 477 478 482 +1292 54 472 477 478 483 +1293 54 472 477 479 484 +1294 54 472 477 479 485 +1295 54 472 477 479 486 +1296 55 478 477 479 484 +1297 55 478 477 479 485 +1298 55 478 477 479 486 +1299 56 479 477 478 480 +1300 55 479 477 478 482 +1301 55 479 477 478 483 +1302 12 481 477 478 480 +1303 13 481 477 478 482 +1304 13 481 477 478 483 +1305 13 481 477 479 484 +1306 13 481 477 479 485 +1307 13 481 477 479 486 +1308 21 477 478 480 487 +1309 21 477 478 480 488 +1310 21 477 478 480 489 +1311 23 482 478 480 487 +1312 23 482 478 480 488 +1313 23 482 478 480 489 +1314 23 483 478 480 487 +1315 23 483 478 480 488 +1316 23 483 478 480 489 +1317 26 473 490 491 492 +1318 27 473 490 491 495 +1319 28 473 490 491 496 +1320 29 494 490 491 492 +1321 30 494 490 491 495 +1322 31 494 490 491 496 +1323 32 490 491 492 493 +1324 33 490 491 492 507 +1325 34 490 491 496 497 +1326 35 490 491 496 501 +1327 35 490 491 496 502 +1328 8 492 491 496 497 +1329 9 492 491 496 501 +1330 9 492 491 496 502 +1331 10 495 491 492 493 +1332 11 495 491 492 507 +1333 12 495 491 496 497 +1334 13 495 491 496 501 +1335 13 495 491 496 502 +1336 14 496 491 492 493 +1337 15 496 491 492 507 +1338 16 491 492 507 508 +1339 17 491 492 507 511 +1340 18 493 492 507 508 +1341 19 493 492 507 511 +1342 36 491 496 497 498 +1343 21 491 496 497 503 +1344 21 491 496 497 504 +1345 37 501 496 497 498 +1346 23 501 496 497 503 +1347 23 501 496 497 504 +1348 37 502 496 497 498 +1349 23 502 496 497 503 +1350 23 502 496 497 504 +1351 38 496 497 498 499 +1352 39 496 497 498 500 +1353 40 503 497 498 499 +1354 41 503 497 498 500 +1355 40 504 497 498 499 +1356 41 504 497 498 500 +1357 42 497 498 500 505 +1358 42 497 498 500 506 +1359 19 499 498 500 505 +1360 19 499 498 500 506 +1361 26 492 507 508 509 +1362 27 492 507 508 512 +1363 28 492 507 508 513 +1364 29 511 507 508 509 +1365 30 511 507 508 512 +1366 31 511 507 508 513 +1367 32 507 508 509 510 +1368 33 507 508 509 519 +1369 141 507 508 513 514 +1370 35 507 508 513 517 +1371 35 507 508 513 518 +1372 142 509 508 513 514 +1373 9 509 508 513 517 +1374 9 509 508 513 518 +1375 10 512 508 509 510 +1376 11 512 508 509 519 +1377 143 512 508 513 514 +1378 13 512 508 513 517 +1379 13 512 508 513 518 +1380 14 513 508 509 510 +1381 15 513 508 509 519 +1382 16 508 509 519 520 +1383 17 508 509 519 523 +1384 18 510 509 519 520 +1385 19 510 509 519 523 +1386 144 508 513 514 515 +1387 144 508 513 514 516 +1388 100 517 513 514 515 +1389 100 517 513 514 516 +1390 100 518 513 514 515 +1391 100 518 513 514 516 +1392 26 509 519 520 521 +1393 27 509 519 520 524 +1394 28 509 519 520 525 +1395 29 523 519 520 521 +1396 30 523 519 520 524 +1397 31 523 519 520 525 +1398 32 519 520 521 522 +1399 33 519 520 521 541 +1400 34 519 520 525 526 +1401 35 519 520 525 530 +1402 35 519 520 525 531 +1403 8 521 520 525 526 +1404 9 521 520 525 530 +1405 9 521 520 525 531 +1406 10 524 520 521 522 +1407 11 524 520 521 541 +1408 12 524 520 525 526 +1409 13 524 520 525 530 +1410 13 524 520 525 531 +1411 14 525 520 521 522 +1412 15 525 520 521 541 +1413 16 520 521 541 542 +1414 17 520 521 541 545 +1415 18 522 521 541 542 +1416 19 522 521 541 545 +1417 67 520 525 526 527 +1418 21 520 525 526 532 +1419 21 520 525 526 533 +1420 68 530 525 526 527 +1421 23 530 525 526 532 +1422 23 530 525 526 533 +1423 68 531 525 526 527 +1424 23 531 525 526 532 +1425 23 531 525 526 533 +1426 69 525 526 527 528 +1427 68 525 526 527 534 +1428 68 525 526 527 535 +1429 68 532 526 527 528 +1430 23 532 526 527 534 +1431 23 532 526 527 535 +1432 68 533 526 527 528 +1433 23 533 526 527 534 +1434 23 533 526 527 535 +1435 70 526 527 528 529 +1436 68 526 527 528 536 +1437 68 526 527 528 537 +1438 71 534 527 528 529 +1439 23 534 527 528 536 +1440 23 534 527 528 537 +1441 71 535 527 528 529 +1442 23 535 527 528 536 +1443 23 535 527 528 537 +1444 72 527 528 529 538 +1445 72 527 528 529 539 +1446 72 527 528 529 540 +1447 73 536 528 529 538 +1448 73 536 528 529 539 +1449 73 536 528 529 540 +1450 73 537 528 529 538 +1451 73 537 528 529 539 +1452 73 537 528 529 540 +1453 26 521 541 542 543 +1454 27 521 541 542 546 +1455 28 521 541 542 547 +1456 29 545 541 542 543 +1457 30 545 541 542 546 +1458 31 545 541 542 547 +1459 32 541 542 543 544 +1460 33 541 542 543 556 +1461 34 541 542 547 548 +1462 35 541 542 547 552 +1463 35 541 542 547 553 +1464 8 543 542 547 548 +1465 9 543 542 547 552 +1466 9 543 542 547 553 +1467 10 546 542 543 544 +1468 11 546 542 543 556 +1469 12 546 542 547 548 +1470 13 546 542 547 552 +1471 13 546 542 547 553 +1472 14 547 542 543 544 +1473 15 547 542 543 556 +1474 85 542 543 556 557 +1475 17 542 543 556 560 +1476 86 544 543 556 557 +1477 19 544 543 556 560 +1478 97 542 547 548 549 +1479 21 542 547 548 554 +1480 21 542 547 548 555 +1481 98 552 547 548 549 +1482 23 552 547 548 554 +1483 23 552 547 548 555 +1484 98 553 547 548 549 +1485 23 553 547 548 554 +1486 23 553 547 548 555 +1487 99 547 548 549 550 +1488 99 547 548 549 551 +1489 100 554 548 549 550 +1490 100 554 548 549 551 +1491 100 555 548 549 550 +1492 100 555 548 549 551 +1493 87 543 556 557 558 +1494 88 543 556 557 561 +1495 88 543 556 557 562 +1496 89 560 556 557 558 +1497 90 560 556 557 561 +1498 90 560 556 557 562 +1499 91 556 557 558 559 +1500 92 556 557 558 563 +1501 93 561 557 558 559 +1502 94 561 557 558 563 +1503 93 562 557 558 559 +1504 94 562 557 558 563 +1505 95 557 558 563 564 +1506 96 557 558 563 567 +1507 18 559 558 563 564 +1508 19 559 558 563 567 +1509 26 558 563 564 565 +1510 27 558 563 564 568 +1511 43 558 563 564 569 +1512 29 567 563 564 565 +1513 30 567 563 564 568 +1514 44 567 563 564 569 +1515 32 563 564 565 566 +1516 101 563 564 565 582 +1517 45 563 564 569 570 +1518 45 563 564 569 571 +1519 46 563 564 569 573 +1520 47 565 564 569 570 +1521 47 565 564 569 571 +1522 48 565 564 569 573 +1523 10 568 564 565 566 +1524 102 568 564 565 582 +1525 49 568 564 569 570 +1526 49 568 564 569 571 +1527 50 568 564 569 573 +1528 51 569 564 565 566 +1529 150 569 564 565 582 +1530 104 564 565 582 583 +1531 105 564 565 582 589 +1532 106 566 565 582 583 +1533 107 566 565 582 589 +1534 53 564 569 570 572 +1535 54 564 569 570 574 +1536 54 564 569 570 575 +1537 54 564 569 571 576 +1538 54 564 569 571 577 +1539 54 564 569 571 578 +1540 55 570 569 571 576 +1541 55 570 569 571 577 +1542 55 570 569 571 578 +1543 56 571 569 570 572 +1544 55 571 569 570 574 +1545 55 571 569 570 575 +1546 12 573 569 570 572 +1547 13 573 569 570 574 +1548 13 573 569 570 575 +1549 13 573 569 571 576 +1550 13 573 569 571 577 +1551 13 573 569 571 578 +1552 21 569 570 572 579 +1553 21 569 570 572 580 +1554 21 569 570 572 581 +1555 23 574 570 572 579 +1556 23 574 570 572 580 +1557 23 574 570 572 581 +1558 23 575 570 572 579 +1559 23 575 570 572 580 +1560 23 575 570 572 581 +1561 108 565 582 583 584 +1562 109 565 582 583 586 +1563 110 565 582 583 587 +1564 111 565 582 589 588 +1565 112 565 582 589 594 +1566 112 565 582 589 595 +1567 113 583 582 589 588 +1568 114 583 582 589 594 +1569 114 583 582 589 595 +1570 115 589 582 583 584 +1571 116 589 582 583 586 +1572 117 589 582 583 587 +1573 118 582 583 584 585 +1574 151 582 583 584 596 +1575 120 582 583 587 588 +1576 121 582 583 587 590 +1577 121 582 583 587 591 +1578 122 584 583 587 588 +1579 123 584 583 587 590 +1580 123 584 583 587 591 +1581 10 586 583 584 585 +1582 102 586 583 584 596 +1583 124 586 583 587 588 +1584 125 586 583 587 590 +1585 125 586 583 587 591 +1586 126 587 583 584 585 +1587 152 587 583 584 596 +1588 104 583 584 596 597 +1589 105 583 584 596 603 +1590 106 585 584 596 597 +1591 107 585 584 596 603 +1592 128 583 587 588 589 +1593 129 583 587 588 592 +1594 129 583 587 588 593 +1595 130 590 587 588 589 +1596 131 590 587 588 592 +1597 131 590 587 588 593 +1598 130 591 587 588 589 +1599 131 591 587 588 592 +1600 131 591 587 588 593 +1601 132 587 588 589 582 +1602 133 587 588 589 594 +1603 133 587 588 589 595 +1604 134 592 588 589 582 +1605 135 592 588 589 594 +1606 135 592 588 589 595 +1607 134 593 588 589 582 +1608 135 593 588 589 594 +1609 135 593 588 589 595 +1610 108 584 596 597 598 +1611 109 584 596 597 600 +1612 110 584 596 597 601 +1613 111 584 596 603 602 +1614 112 584 596 603 608 +1615 112 584 596 603 609 +1616 113 597 596 603 602 +1617 114 597 596 603 608 +1618 114 597 596 603 609 +1619 115 603 596 597 598 +1620 116 603 596 597 600 +1621 117 603 596 597 601 +1622 118 596 597 598 599 +1623 119 596 597 598 610 +1624 120 596 597 601 602 +1625 121 596 597 601 604 +1626 121 596 597 601 605 +1627 122 598 597 601 602 +1628 123 598 597 601 604 +1629 123 598 597 601 605 +1630 10 600 597 598 599 +1631 11 600 597 598 610 +1632 124 600 597 601 602 +1633 125 600 597 601 604 +1634 125 600 597 601 605 +1635 126 601 597 598 599 +1636 127 601 597 598 610 +1637 16 597 598 610 611 +1638 17 597 598 610 614 +1639 18 599 598 610 611 +1640 19 599 598 610 614 +1641 128 597 601 602 603 +1642 129 597 601 602 606 +1643 129 597 601 602 607 +1644 130 604 601 602 603 +1645 131 604 601 602 606 +1646 131 604 601 602 607 +1647 130 605 601 602 603 +1648 131 605 601 602 606 +1649 131 605 601 602 607 +1650 132 601 602 603 596 +1651 133 601 602 603 608 +1652 133 601 602 603 609 +1653 134 606 602 603 596 +1654 135 606 602 603 608 +1655 135 606 602 603 609 +1656 134 607 602 603 596 +1657 135 607 602 603 608 +1658 135 607 602 603 609 +1659 26 598 610 611 612 +1660 27 598 610 611 615 +1661 28 598 610 611 616 +1662 29 614 610 611 612 +1663 30 614 610 611 615 +1664 31 614 610 611 616 +1665 32 610 611 612 613 +1666 33 610 611 612 622 +1667 141 610 611 616 617 +1668 35 610 611 616 620 +1669 35 610 611 616 621 +1670 142 612 611 616 617 +1671 9 612 611 616 620 +1672 9 612 611 616 621 +1673 10 615 611 612 613 +1674 11 615 611 612 622 +1675 143 615 611 616 617 +1676 13 615 611 616 620 +1677 13 615 611 616 621 +1678 14 616 611 612 613 +1679 15 616 611 612 622 +1680 16 611 612 622 623 +1681 17 611 612 622 626 +1682 18 613 612 622 623 +1683 19 613 612 622 626 +1684 144 611 616 617 618 +1685 144 611 616 617 619 +1686 100 620 616 617 618 +1687 100 620 616 617 619 +1688 100 621 616 617 618 +1689 100 621 616 617 619 +1690 26 612 622 623 624 +1691 27 612 622 623 627 +1692 28 612 622 623 628 +1693 29 626 622 623 624 +1694 30 626 622 623 627 +1695 31 626 622 623 628 +1696 32 622 623 624 625 +1697 33 622 623 624 639 +1698 34 622 623 628 629 +1699 35 622 623 628 633 +1700 35 622 623 628 634 +1701 8 624 623 628 629 +1702 9 624 623 628 633 +1703 9 624 623 628 634 +1704 10 627 623 624 625 +1705 11 627 623 624 639 +1706 12 627 623 628 629 +1707 13 627 623 628 633 +1708 13 627 623 628 634 +1709 14 628 623 624 625 +1710 15 628 623 624 639 +1711 16 623 624 639 640 +1712 17 623 624 639 643 +1713 18 625 624 639 640 +1714 19 625 624 639 643 +1715 36 623 628 629 630 +1716 21 623 628 629 635 +1717 21 623 628 629 636 +1718 37 633 628 629 630 +1719 23 633 628 629 635 +1720 23 633 628 629 636 +1721 37 634 628 629 630 +1722 23 634 628 629 635 +1723 23 634 628 629 636 +1724 38 628 629 630 631 +1725 39 628 629 630 632 +1726 40 635 629 630 631 +1727 41 635 629 630 632 +1728 40 636 629 630 631 +1729 41 636 629 630 632 +1730 42 629 630 632 637 +1731 42 629 630 632 638 +1732 19 631 630 632 637 +1733 19 631 630 632 638 +1734 26 624 639 640 641 +1735 27 624 639 640 644 +1736 28 624 639 640 645 +1737 29 643 639 640 641 +1738 30 643 639 640 644 +1739 31 643 639 640 645 +1740 32 639 640 641 642 +1741 33 639 640 641 656 +1742 34 639 640 645 646 +1743 35 639 640 645 650 +1744 35 639 640 645 651 +1745 8 641 640 645 646 +1746 9 641 640 645 650 +1747 9 641 640 645 651 +1748 10 644 640 641 642 +1749 11 644 640 641 656 +1750 12 644 640 645 646 +1751 13 644 640 645 650 +1752 13 644 640 645 651 +1753 14 645 640 641 642 +1754 15 645 640 641 656 +1755 16 640 641 656 657 +1756 17 640 641 656 660 +1757 18 642 641 656 657 +1758 19 642 641 656 660 +1759 36 640 645 646 647 +1760 21 640 645 646 652 +1761 21 640 645 646 653 +1762 37 650 645 646 647 +1763 23 650 645 646 652 +1764 23 650 645 646 653 +1765 37 651 645 646 647 +1766 23 651 645 646 652 +1767 23 651 645 646 653 +1768 38 645 646 647 648 +1769 39 645 646 647 649 +1770 40 652 646 647 648 +1771 41 652 646 647 649 +1772 40 653 646 647 648 +1773 41 653 646 647 649 +1774 42 646 647 649 654 +1775 42 646 647 649 655 +1776 19 648 647 649 654 +1777 19 648 647 649 655 +1778 26 641 656 657 658 +1779 27 641 656 657 661 +1780 28 641 656 657 662 +1781 29 660 656 657 658 +1782 30 660 656 657 661 +1783 31 660 656 657 662 +1784 32 656 657 658 659 +1785 33 656 657 658 680 +1786 34 656 657 662 663 +1787 35 656 657 662 669 +1788 35 656 657 662 670 +1789 8 658 657 662 663 +1790 9 658 657 662 669 +1791 9 658 657 662 670 +1792 10 661 657 658 659 +1793 11 661 657 658 680 +1794 12 661 657 662 663 +1795 13 661 657 662 669 +1796 13 661 657 662 670 +1797 14 662 657 658 659 +1798 15 662 657 658 680 +1799 16 657 658 680 681 +1800 17 657 658 680 684 +1801 18 659 658 680 681 +1802 19 659 658 680 684 +1803 67 657 662 663 664 +1804 21 657 662 663 671 +1805 21 657 662 663 672 +1806 68 669 662 663 664 +1807 23 669 662 663 671 +1808 23 669 662 663 672 +1809 68 670 662 663 664 +1810 23 670 662 663 671 +1811 23 670 662 663 672 +1812 153 662 663 664 665 +1813 68 662 663 664 673 +1814 68 662 663 664 674 +1815 154 671 663 664 665 +1816 23 671 663 664 673 +1817 23 671 663 664 674 +1818 154 672 663 664 665 +1819 23 672 663 664 673 +1820 23 672 663 664 674 +1821 155 663 664 665 666 +1822 156 663 664 665 675 +1823 157 673 664 665 666 +1824 158 673 664 665 675 +1825 157 674 664 665 666 +1826 158 674 664 665 675 +1827 159 664 665 666 667 +1828 159 664 665 666 668 +1829 160 675 665 666 667 +1830 160 675 665 666 668 +1831 160 665 666 667 676 +1832 160 665 666 667 677 +1833 160 665 666 668 678 +1834 160 665 666 668 679 +1835 160 667 666 668 678 +1836 160 667 666 668 679 +1837 160 668 666 667 676 +1838 160 668 666 667 677 +1839 26 658 680 681 682 +1840 27 658 680 681 685 +1841 28 658 680 681 686 +1842 29 684 680 681 682 +1843 30 684 680 681 685 +1844 31 684 680 681 686 +1845 32 680 681 682 683 +1846 33 680 681 682 699 +1847 81 680 681 686 687 +1848 35 680 681 686 690 +1849 35 680 681 686 691 +1850 82 682 681 686 687 +1851 9 682 681 686 690 +1852 9 682 681 686 691 +1853 10 685 681 682 683 +1854 11 685 681 682 699 +1855 83 685 681 686 687 +1856 13 685 681 686 690 +1857 13 685 681 686 691 +1858 14 686 681 682 683 +1859 15 686 681 682 699 +1860 16 681 682 699 700 +1861 17 681 682 699 703 +1862 18 683 682 699 700 +1863 19 683 682 699 703 +1864 84 681 686 687 688 +1865 84 681 686 687 689 +1866 83 681 686 687 692 +1867 55 690 686 687 688 +1868 55 690 686 687 689 +1869 13 690 686 687 692 +1870 55 691 686 687 688 +1871 55 691 686 687 689 +1872 13 691 686 687 692 +1873 55 686 687 688 693 +1874 55 686 687 688 694 +1875 55 686 687 688 695 +1876 55 686 687 689 696 +1877 55 686 687 689 697 +1878 55 686 687 689 698 +1879 55 688 687 689 696 +1880 55 688 687 689 697 +1881 55 688 687 689 698 +1882 55 689 687 688 693 +1883 55 689 687 688 694 +1884 55 689 687 688 695 +1885 13 692 687 688 693 +1886 13 692 687 688 694 +1887 13 692 687 688 695 +1888 13 692 687 689 696 +1889 13 692 687 689 697 +1890 13 692 687 689 698 +1891 26 682 699 700 701 +1892 27 682 699 700 704 +1893 43 682 699 700 705 +1894 29 703 699 700 701 +1895 30 703 699 700 704 +1896 44 703 699 700 705 +1897 32 699 700 701 702 +1898 33 699 700 701 718 +1899 45 699 700 705 706 +1900 45 699 700 705 707 +1901 46 699 700 705 709 +1902 47 701 700 705 706 +1903 47 701 700 705 707 +1904 48 701 700 705 709 +1905 10 704 700 701 702 +1906 11 704 700 701 718 +1907 49 704 700 705 706 +1908 49 704 700 705 707 +1909 50 704 700 705 709 +1910 51 705 700 701 702 +1911 52 705 700 701 718 +1912 16 700 701 718 719 +1913 17 700 701 718 722 +1914 18 702 701 718 719 +1915 19 702 701 718 722 +1916 53 700 705 706 708 +1917 54 700 705 706 710 +1918 54 700 705 706 711 +1919 54 700 705 707 712 +1920 54 700 705 707 713 +1921 54 700 705 707 714 +1922 55 706 705 707 712 +1923 55 706 705 707 713 +1924 55 706 705 707 714 +1925 56 707 705 706 708 +1926 55 707 705 706 710 +1927 55 707 705 706 711 +1928 12 709 705 706 708 +1929 13 709 705 706 710 +1930 13 709 705 706 711 +1931 13 709 705 707 712 +1932 13 709 705 707 713 +1933 13 709 705 707 714 +1934 21 705 706 708 715 +1935 21 705 706 708 716 +1936 21 705 706 708 717 +1937 23 710 706 708 715 +1938 23 710 706 708 716 +1939 23 710 706 708 717 +1940 23 711 706 708 715 +1941 23 711 706 708 716 +1942 23 711 706 708 717 +1943 26 701 718 719 720 +1944 27 701 718 719 723 +1945 28 701 718 719 724 +1946 29 722 718 719 720 +1947 30 722 718 719 723 +1948 31 722 718 719 724 +1949 32 718 719 720 721 +1950 33 718 719 720 738 +1951 57 718 719 724 725 +1952 35 718 719 724 731 +1953 35 718 719 724 732 +1954 58 720 719 724 725 +1955 9 720 719 724 731 +1956 9 720 719 724 732 +1957 10 723 719 720 721 +1958 11 723 719 720 738 +1959 59 723 719 724 725 +1960 13 723 719 724 731 +1961 13 723 719 724 732 +1962 14 724 719 720 721 +1963 15 724 719 720 738 +1964 16 719 720 738 739 +1965 17 719 720 738 742 +1966 18 721 720 738 739 +1967 19 721 720 738 742 +1968 60 719 724 725 726 +1969 60 719 724 725 727 +1970 61 731 724 725 726 +1971 61 731 724 725 727 +1972 61 732 724 725 726 +1973 61 732 724 725 727 +1974 62 724 725 726 728 +1975 63 724 725 726 733 +1976 62 724 725 727 729 +1977 63 724 725 727 734 +1978 64 726 725 727 729 +1979 65 726 725 727 734 +1980 64 727 725 726 728 +1981 65 727 725 726 733 +1982 64 725 726 728 730 +1983 65 725 726 728 735 +1984 65 733 726 728 730 +1985 66 733 726 728 735 +1986 64 725 727 729 730 +1987 65 725 727 729 736 +1988 65 734 727 729 730 +1989 66 734 727 729 736 +1990 64 726 728 730 729 +1991 65 726 728 730 737 +1992 65 735 728 730 729 +1993 66 735 728 730 737 +1994 64 727 729 730 728 +1995 65 727 729 730 737 +1996 65 736 729 730 728 +1997 66 736 729 730 737 +1998 26 720 738 739 740 +1999 27 720 738 739 743 +2000 28 720 738 739 744 +2001 29 742 738 739 740 +2002 30 742 738 739 743 +2003 31 742 738 739 744 +2004 32 738 739 740 741 +2005 33 738 739 740 748 +2006 35 738 739 744 745 +2007 35 738 739 744 746 +2008 35 738 739 744 747 +2009 9 740 739 744 745 +2010 9 740 739 744 746 +2011 9 740 739 744 747 +2012 10 743 739 740 741 +2013 11 743 739 740 748 +2014 13 743 739 744 745 +2015 13 743 739 744 746 +2016 13 743 739 744 747 +2017 14 744 739 740 741 +2018 15 744 739 740 748 +2019 85 739 740 748 749 +2020 17 739 740 748 752 +2021 86 741 740 748 749 +2022 19 741 740 748 752 +2023 87 740 748 749 750 +2024 88 740 748 749 753 +2025 88 740 748 749 754 +2026 89 752 748 749 750 +2027 90 752 748 749 753 +2028 90 752 748 749 754 +2029 91 748 749 750 751 +2030 92 748 749 750 755 +2031 93 753 749 750 751 +2032 94 753 749 750 755 +2033 93 754 749 750 751 +2034 94 754 749 750 755 +2035 95 749 750 755 756 +2036 96 749 750 755 759 +2037 18 751 750 755 756 +2038 19 751 750 755 759 +2039 26 750 755 756 757 +2040 27 750 755 756 760 +2041 28 750 755 756 761 +2042 29 759 755 756 757 +2043 30 759 755 756 760 +2044 31 759 755 756 761 +2045 32 755 756 757 758 +2046 33 755 756 757 777 +2047 34 755 756 761 762 +2048 35 755 756 761 766 +2049 35 755 756 761 767 +2050 8 757 756 761 762 +2051 9 757 756 761 766 +2052 9 757 756 761 767 +2053 10 760 756 757 758 +2054 11 760 756 757 777 +2055 12 760 756 761 762 +2056 13 760 756 761 766 +2057 13 760 756 761 767 +2058 14 761 756 757 758 +2059 15 761 756 757 777 +2060 16 756 757 777 778 +2061 17 756 757 777 781 +2062 18 758 757 777 778 +2063 19 758 757 777 781 +2064 67 756 761 762 763 +2065 21 756 761 762 768 +2066 21 756 761 762 769 +2067 68 766 761 762 763 +2068 23 766 761 762 768 +2069 23 766 761 762 769 +2070 68 767 761 762 763 +2071 23 767 761 762 768 +2072 23 767 761 762 769 +2073 69 761 762 763 764 +2074 68 761 762 763 770 +2075 68 761 762 763 771 +2076 68 768 762 763 764 +2077 23 768 762 763 770 +2078 23 768 762 763 771 +2079 68 769 762 763 764 +2080 23 769 762 763 770 +2081 23 769 762 763 771 +2082 70 762 763 764 765 +2083 68 762 763 764 772 +2084 68 762 763 764 773 +2085 71 770 763 764 765 +2086 23 770 763 764 772 +2087 23 770 763 764 773 +2088 71 771 763 764 765 +2089 23 771 763 764 772 +2090 23 771 763 764 773 +2091 72 763 764 765 774 +2092 72 763 764 765 775 +2093 72 763 764 765 776 +2094 73 772 764 765 774 +2095 73 772 764 765 775 +2096 73 772 764 765 776 +2097 73 773 764 765 774 +2098 73 773 764 765 775 +2099 73 773 764 765 776 +2100 26 757 777 778 779 +2101 27 757 777 778 782 +2102 28 757 777 778 783 +2103 29 781 777 778 779 +2104 30 781 777 778 782 +2105 31 781 777 778 783 +2106 32 777 778 779 780 +2107 33 777 778 779 794 +2108 34 777 778 783 784 +2109 35 777 778 783 788 +2110 35 777 778 783 789 +2111 8 779 778 783 784 +2112 9 779 778 783 788 +2113 9 779 778 783 789 +2114 10 782 778 779 780 +2115 11 782 778 779 794 +2116 12 782 778 783 784 +2117 13 782 778 783 788 +2118 13 782 778 783 789 +2119 14 783 778 779 780 +2120 15 783 778 779 794 +2121 16 778 779 794 795 +2122 17 778 779 794 798 +2123 18 780 779 794 795 +2124 19 780 779 794 798 +2125 36 778 783 784 785 +2126 21 778 783 784 790 +2127 21 778 783 784 791 +2128 37 788 783 784 785 +2129 23 788 783 784 790 +2130 23 788 783 784 791 +2131 37 789 783 784 785 +2132 23 789 783 784 790 +2133 23 789 783 784 791 +2134 38 783 784 785 786 +2135 39 783 784 785 787 +2136 40 790 784 785 786 +2137 41 790 784 785 787 +2138 40 791 784 785 786 +2139 41 791 784 785 787 +2140 42 784 785 787 792 +2141 42 784 785 787 793 +2142 19 786 785 787 792 +2143 19 786 785 787 793 +2144 26 779 794 795 796 +2145 27 779 794 795 799 +2146 28 779 794 795 800 +2147 29 798 794 795 796 +2148 30 798 794 795 799 +2149 31 798 794 795 800 +2150 32 794 795 796 797 +2151 33 794 795 796 813 +2152 81 794 795 800 801 +2153 35 794 795 800 804 +2154 35 794 795 800 805 +2155 82 796 795 800 801 +2156 9 796 795 800 804 +2157 9 796 795 800 805 +2158 10 799 795 796 797 +2159 11 799 795 796 813 +2160 83 799 795 800 801 +2161 13 799 795 800 804 +2162 13 799 795 800 805 +2163 14 800 795 796 797 +2164 15 800 795 796 813 +2165 16 795 796 813 814 +2166 17 795 796 813 817 +2167 18 797 796 813 814 +2168 19 797 796 813 817 +2169 84 795 800 801 802 +2170 84 795 800 801 803 +2171 83 795 800 801 806 +2172 55 804 800 801 802 +2173 55 804 800 801 803 +2174 13 804 800 801 806 +2175 55 805 800 801 802 +2176 55 805 800 801 803 +2177 13 805 800 801 806 +2178 55 800 801 802 807 +2179 55 800 801 802 808 +2180 55 800 801 802 809 +2181 55 800 801 803 810 +2182 55 800 801 803 811 +2183 55 800 801 803 812 +2184 55 802 801 803 810 +2185 55 802 801 803 811 +2186 55 802 801 803 812 +2187 55 803 801 802 807 +2188 55 803 801 802 808 +2189 55 803 801 802 809 +2190 13 806 801 802 807 +2191 13 806 801 802 808 +2192 13 806 801 802 809 +2193 13 806 801 803 810 +2194 13 806 801 803 811 +2195 13 806 801 803 812 +2196 26 796 813 814 815 +2197 27 796 813 814 818 +2198 28 796 813 814 819 +2199 29 817 813 814 815 +2200 30 817 813 814 818 +2201 31 817 813 814 819 +2202 32 813 814 815 816 +2203 33 813 814 815 828 +2204 34 813 814 819 820 +2205 35 813 814 819 824 +2206 35 813 814 819 825 +2207 8 815 814 819 820 +2208 9 815 814 819 824 +2209 9 815 814 819 825 +2210 10 818 814 815 816 +2211 11 818 814 815 828 +2212 12 818 814 819 820 +2213 13 818 814 819 824 +2214 13 818 814 819 825 +2215 14 819 814 815 816 +2216 15 819 814 815 828 +2217 16 814 815 828 829 +2218 17 814 815 828 832 +2219 18 816 815 828 829 +2220 19 816 815 828 832 +2221 97 814 819 820 821 +2222 21 814 819 820 826 +2223 21 814 819 820 827 +2224 98 824 819 820 821 +2225 23 824 819 820 826 +2226 23 824 819 820 827 +2227 98 825 819 820 821 +2228 23 825 819 820 826 +2229 23 825 819 820 827 +2230 99 819 820 821 822 +2231 99 819 820 821 823 +2232 100 826 820 821 822 +2233 100 826 820 821 823 +2234 100 827 820 821 822 +2235 100 827 820 821 823 +2236 26 815 828 829 830 +2237 27 815 828 829 833 +2238 28 815 828 829 834 +2239 29 832 828 829 830 +2240 30 832 828 829 833 +2241 31 832 828 829 834 +2242 32 828 829 830 831 +2243 33 828 829 830 840 +2244 141 828 829 834 835 +2245 35 828 829 834 838 +2246 35 828 829 834 839 +2247 142 830 829 834 835 +2248 9 830 829 834 838 +2249 9 830 829 834 839 +2250 10 833 829 830 831 +2251 11 833 829 830 840 +2252 143 833 829 834 835 +2253 13 833 829 834 838 +2254 13 833 829 834 839 +2255 14 834 829 830 831 +2256 15 834 829 830 840 +2257 85 829 830 840 841 +2258 17 829 830 840 844 +2259 86 831 830 840 841 +2260 19 831 830 840 844 +2261 144 829 834 835 836 +2262 144 829 834 835 837 +2263 100 838 834 835 836 +2264 100 838 834 835 837 +2265 100 839 834 835 836 +2266 100 839 834 835 837 +2267 87 830 840 841 842 +2268 88 830 840 841 845 +2269 88 830 840 841 846 +2270 89 844 840 841 842 +2271 90 844 840 841 845 +2272 90 844 840 841 846 +2273 91 840 841 842 843 +2274 92 840 841 842 847 +2275 93 845 841 842 843 +2276 94 845 841 842 847 +2277 93 846 841 842 843 +2278 94 846 841 842 847 +2279 95 841 842 847 848 +2280 96 841 842 847 851 +2281 18 843 842 847 848 +2282 19 843 842 847 851 +2283 26 842 847 848 849 +2284 27 842 847 848 852 +2285 28 842 847 848 853 +2286 29 851 847 848 849 +2287 30 851 847 848 852 +2288 31 851 847 848 853 +2289 32 847 848 849 850 +2290 33 847 848 849 871 +2291 34 847 848 853 854 +2292 35 847 848 853 860 +2293 35 847 848 853 861 +2294 8 849 848 853 854 +2295 9 849 848 853 860 +2296 9 849 848 853 861 +2297 10 852 848 849 850 +2298 11 852 848 849 871 +2299 12 852 848 853 854 +2300 13 852 848 853 860 +2301 13 852 848 853 861 +2302 14 853 848 849 850 +2303 15 853 848 849 871 +2304 16 848 849 871 872 +2305 17 848 849 871 875 +2306 18 850 849 871 872 +2307 19 850 849 871 875 +2308 67 848 853 854 855 +2309 21 848 853 854 862 +2310 21 848 853 854 863 +2311 68 860 853 854 855 +2312 23 860 853 854 862 +2313 23 860 853 854 863 +2314 68 861 853 854 855 +2315 23 861 853 854 862 +2316 23 861 853 854 863 +2317 153 853 854 855 856 +2318 68 853 854 855 864 +2319 68 853 854 855 865 +2320 154 862 854 855 856 +2321 23 862 854 855 864 +2322 23 862 854 855 865 +2323 154 863 854 855 856 +2324 23 863 854 855 864 +2325 23 863 854 855 865 +2326 155 854 855 856 857 +2327 156 854 855 856 866 +2328 157 864 855 856 857 +2329 158 864 855 856 866 +2330 157 865 855 856 857 +2331 158 865 855 856 866 +2332 159 855 856 857 858 +2333 159 855 856 857 859 +2334 160 866 856 857 858 +2335 160 866 856 857 859 +2336 160 856 857 858 867 +2337 160 856 857 858 868 +2338 160 856 857 859 869 +2339 160 856 857 859 870 +2340 160 858 857 859 869 +2341 160 858 857 859 870 +2342 160 859 857 858 867 +2343 160 859 857 858 868 +2344 26 849 871 872 873 +2345 27 849 871 872 876 +2346 43 849 871 872 877 +2347 29 875 871 872 873 +2348 30 875 871 872 876 +2349 44 875 871 872 877 +2350 32 871 872 873 874 +2351 33 871 872 873 885 +2352 74 871 872 877 878 +2353 45 871 872 877 879 +2354 46 871 872 877 880 +2355 75 873 872 877 878 +2356 47 873 872 877 879 +2357 48 873 872 877 880 +2358 10 876 872 873 874 +2359 11 876 872 873 885 +2360 76 876 872 877 878 +2361 49 876 872 877 879 +2362 50 876 872 877 880 +2363 51 877 872 873 874 +2364 52 877 872 873 885 +2365 16 872 873 885 886 +2366 17 872 873 885 889 +2367 18 874 873 885 886 +2368 19 874 873 885 889 +2369 77 872 877 878 881 +2370 54 872 877 879 882 +2371 54 872 877 879 883 +2372 54 872 877 879 884 +2373 78 878 877 879 882 +2374 78 878 877 879 883 +2375 78 878 877 879 884 +2376 79 879 877 878 881 +2377 80 880 877 878 881 +2378 13 880 877 879 882 +2379 13 880 877 879 883 +2380 13 880 877 879 884 +2381 26 873 885 886 887 +2382 27 873 885 886 890 +2383 28 873 885 886 891 +2384 29 889 885 886 887 +2385 30 889 885 886 890 +2386 31 889 885 886 891 +2387 32 885 886 887 888 +2388 33 885 886 887 904 +2389 81 885 886 891 892 +2390 35 885 886 891 895 +2391 35 885 886 891 896 +2392 82 887 886 891 892 +2393 9 887 886 891 895 +2394 9 887 886 891 896 +2395 10 890 886 887 888 +2396 11 890 886 887 904 +2397 83 890 886 891 892 +2398 13 890 886 891 895 +2399 13 890 886 891 896 +2400 14 891 886 887 888 +2401 15 891 886 887 904 +2402 16 886 887 904 905 +2403 17 886 887 904 908 +2404 18 888 887 904 905 +2405 19 888 887 904 908 +2406 84 886 891 892 893 +2407 84 886 891 892 894 +2408 83 886 891 892 897 +2409 55 895 891 892 893 +2410 55 895 891 892 894 +2411 13 895 891 892 897 +2412 55 896 891 892 893 +2413 55 896 891 892 894 +2414 13 896 891 892 897 +2415 55 891 892 893 898 +2416 55 891 892 893 899 +2417 55 891 892 893 900 +2418 55 891 892 894 901 +2419 55 891 892 894 902 +2420 55 891 892 894 903 +2421 55 893 892 894 901 +2422 55 893 892 894 902 +2423 55 893 892 894 903 +2424 55 894 892 893 898 +2425 55 894 892 893 899 +2426 55 894 892 893 900 +2427 13 897 892 893 898 +2428 13 897 892 893 899 +2429 13 897 892 893 900 +2430 13 897 892 894 901 +2431 13 897 892 894 902 +2432 13 897 892 894 903 +2433 26 887 904 905 906 +2434 27 887 904 905 909 +2435 28 887 904 905 910 +2436 29 908 904 905 906 +2437 30 908 904 905 909 +2438 31 908 904 905 910 +2439 32 904 905 906 907 +2440 33 904 905 906 915 +2441 136 904 905 910 911 +2442 35 904 905 910 912 +2443 35 904 905 910 913 +2444 137 906 905 910 911 +2445 9 906 905 910 912 +2446 9 906 905 910 913 +2447 10 909 905 906 907 +2448 11 909 905 906 915 +2449 138 909 905 910 911 +2450 13 909 905 910 912 +2451 13 909 905 910 913 +2452 14 910 905 906 907 +2453 15 910 905 906 915 +2454 16 905 906 915 916 +2455 17 905 906 915 919 +2456 18 907 906 915 916 +2457 19 907 906 915 919 +2458 139 905 910 911 914 +2459 140 912 910 911 914 +2460 140 913 910 911 914 +2461 26 906 915 916 917 +2462 27 906 915 916 920 +2463 28 906 915 916 921 +2464 29 919 915 916 917 +2465 30 919 915 916 920 +2466 31 919 915 916 921 +2467 32 915 916 917 918 +2468 33 915 916 917 927 +2469 141 915 916 921 922 +2470 35 915 916 921 925 +2471 35 915 916 921 926 +2472 142 917 916 921 922 +2473 9 917 916 921 925 +2474 9 917 916 921 926 +2475 10 920 916 917 918 +2476 11 920 916 917 927 +2477 143 920 916 921 922 +2478 13 920 916 921 925 +2479 13 920 916 921 926 +2480 14 921 916 917 918 +2481 15 921 916 917 927 +2482 16 916 917 927 928 +2483 17 916 917 927 931 +2484 18 918 917 927 928 +2485 19 918 917 927 931 +2486 144 916 921 922 923 +2487 144 916 921 922 924 +2488 100 925 921 922 923 +2489 100 925 921 922 924 +2490 100 926 921 922 923 +2491 100 926 921 922 924 +2492 26 917 927 928 929 +2493 27 917 927 928 932 +2494 28 917 927 928 933 +2495 29 931 927 928 929 +2496 30 931 927 928 932 +2497 31 931 927 928 933 +2498 32 927 928 929 930 +2499 33 927 928 929 948 +2500 57 927 928 933 934 +2501 35 927 928 933 941 +2502 35 927 928 933 942 +2503 58 929 928 933 934 +2504 9 929 928 933 941 +2505 9 929 928 933 942 +2506 10 932 928 929 930 +2507 11 932 928 929 948 +2508 59 932 928 933 934 +2509 13 932 928 933 941 +2510 13 932 928 933 942 +2511 14 933 928 929 930 +2512 15 933 928 929 948 +2513 16 928 929 948 949 +2514 17 928 929 948 952 +2515 18 930 929 948 949 +2516 19 930 929 948 952 +2517 60 928 933 934 935 +2518 60 928 933 934 936 +2519 61 941 933 934 935 +2520 61 941 933 934 936 +2521 61 942 933 934 935 +2522 61 942 933 934 936 +2523 62 933 934 935 937 +2524 63 933 934 935 943 +2525 62 933 934 936 938 +2526 63 933 934 936 944 +2527 64 935 934 936 938 +2528 65 935 934 936 944 +2529 64 936 934 935 937 +2530 65 936 934 935 943 +2531 64 934 935 937 939 +2532 65 934 935 937 945 +2533 65 943 935 937 939 +2534 66 943 935 937 945 +2535 64 934 936 938 939 +2536 65 934 936 938 946 +2537 65 944 936 938 939 +2538 66 944 936 938 946 +2539 64 935 937 939 938 +2540 161 935 937 939 940 +2541 65 945 937 939 938 +2542 162 945 937 939 940 +2543 64 936 938 939 937 +2544 161 936 938 939 940 +2545 65 946 938 939 937 +2546 162 946 938 939 940 +2547 163 937 939 940 947 +2548 163 938 939 940 947 +2549 26 929 948 949 950 +2550 27 929 948 949 953 +2551 28 929 948 949 954 +2552 29 952 948 949 950 +2553 30 952 948 949 953 +2554 31 952 948 949 954 +2555 32 948 949 950 951 +2556 33 948 949 950 962 +2557 145 948 949 954 955 +2558 35 948 949 954 958 +2559 35 948 949 954 959 +2560 146 950 949 954 955 +2561 9 950 949 954 958 +2562 9 950 949 954 959 +2563 10 953 949 950 951 +2564 11 953 949 950 962 +2565 147 953 949 954 955 +2566 13 953 949 954 958 +2567 13 953 949 954 959 +2568 14 954 949 950 951 +2569 15 954 949 950 962 +2570 16 949 950 962 963 +2571 17 949 950 962 966 +2572 18 951 950 962 963 +2573 19 951 950 962 966 +2574 148 949 954 955 956 +2575 149 949 954 955 957 +2576 40 958 954 955 956 +2577 41 958 954 955 957 +2578 40 959 954 955 956 +2579 41 959 954 955 957 +2580 42 954 955 957 960 +2581 42 954 955 957 961 +2582 19 956 955 957 960 +2583 19 956 955 957 961 +2584 26 950 962 963 964 +2585 27 950 962 963 967 +2586 43 950 962 963 968 +2587 29 966 962 963 964 +2588 30 966 962 963 967 +2589 44 966 962 963 968 +2590 32 962 963 964 965 +2591 33 962 963 964 981 +2592 45 962 963 968 969 +2593 45 962 963 968 970 +2594 46 962 963 968 972 +2595 47 964 963 968 969 +2596 47 964 963 968 970 +2597 48 964 963 968 972 +2598 10 967 963 964 965 +2599 11 967 963 964 981 +2600 49 967 963 968 969 +2601 49 967 963 968 970 +2602 50 967 963 968 972 +2603 51 968 963 964 965 +2604 52 968 963 964 981 +2605 16 963 964 981 982 +2606 17 963 964 981 985 +2607 18 965 964 981 982 +2608 19 965 964 981 985 +2609 53 963 968 969 971 +2610 54 963 968 969 973 +2611 54 963 968 969 974 +2612 54 963 968 970 975 +2613 54 963 968 970 976 +2614 54 963 968 970 977 +2615 55 969 968 970 975 +2616 55 969 968 970 976 +2617 55 969 968 970 977 +2618 56 970 968 969 971 +2619 55 970 968 969 973 +2620 55 970 968 969 974 +2621 12 972 968 969 971 +2622 13 972 968 969 973 +2623 13 972 968 969 974 +2624 13 972 968 970 975 +2625 13 972 968 970 976 +2626 13 972 968 970 977 +2627 21 968 969 971 978 +2628 21 968 969 971 979 +2629 21 968 969 971 980 +2630 23 973 969 971 978 +2631 23 973 969 971 979 +2632 23 973 969 971 980 +2633 23 974 969 971 978 +2634 23 974 969 971 979 +2635 23 974 969 971 980 +2636 26 964 981 982 983 +2637 27 964 981 982 986 +2638 28 964 981 982 987 +2639 29 985 981 982 983 +2640 30 985 981 982 986 +2641 31 985 981 982 987 +2642 32 981 982 983 984 +2643 33 981 982 983 998 +2644 34 981 982 987 988 +2645 35 981 982 987 992 +2646 35 981 982 987 993 +2647 8 983 982 987 988 +2648 9 983 982 987 992 +2649 9 983 982 987 993 +2650 10 986 982 983 984 +2651 11 986 982 983 998 +2652 12 986 982 987 988 +2653 13 986 982 987 992 +2654 13 986 982 987 993 +2655 14 987 982 983 984 +2656 15 987 982 983 998 +2657 16 982 983 998 999 +2658 17 982 983 998 1002 +2659 18 984 983 998 999 +2660 19 984 983 998 1002 +2661 36 982 987 988 989 +2662 21 982 987 988 994 +2663 21 982 987 988 995 +2664 37 992 987 988 989 +2665 23 992 987 988 994 +2666 23 992 987 988 995 +2667 37 993 987 988 989 +2668 23 993 987 988 994 +2669 23 993 987 988 995 +2670 38 987 988 989 990 +2671 39 987 988 989 991 +2672 40 994 988 989 990 +2673 41 994 988 989 991 +2674 40 995 988 989 990 +2675 41 995 988 989 991 +2676 42 988 989 991 996 +2677 42 988 989 991 997 +2678 19 990 989 991 996 +2679 19 990 989 991 997 +2680 26 983 998 999 1000 +2681 27 983 998 999 1003 +2682 28 983 998 999 1004 +2683 29 1002 998 999 1000 +2684 30 1002 998 999 1003 +2685 31 1002 998 999 1004 +2686 32 998 999 1000 1001 +2687 33 998 999 1000 1020 +2688 34 998 999 1004 1005 +2689 35 998 999 1004 1009 +2690 35 998 999 1004 1010 +2691 8 1000 999 1004 1005 +2692 9 1000 999 1004 1009 +2693 9 1000 999 1004 1010 +2694 10 1003 999 1000 1001 +2695 11 1003 999 1000 1020 +2696 12 1003 999 1004 1005 +2697 13 1003 999 1004 1009 +2698 13 1003 999 1004 1010 +2699 14 1004 999 1000 1001 +2700 15 1004 999 1000 1020 +2701 16 999 1000 1020 1021 +2702 17 999 1000 1020 1024 +2703 18 1001 1000 1020 1021 +2704 19 1001 1000 1020 1024 +2705 67 999 1004 1005 1006 +2706 21 999 1004 1005 1011 +2707 21 999 1004 1005 1012 +2708 68 1009 1004 1005 1006 +2709 23 1009 1004 1005 1011 +2710 23 1009 1004 1005 1012 +2711 68 1010 1004 1005 1006 +2712 23 1010 1004 1005 1011 +2713 23 1010 1004 1005 1012 +2714 69 1004 1005 1006 1007 +2715 68 1004 1005 1006 1013 +2716 68 1004 1005 1006 1014 +2717 68 1011 1005 1006 1007 +2718 23 1011 1005 1006 1013 +2719 23 1011 1005 1006 1014 +2720 68 1012 1005 1006 1007 +2721 23 1012 1005 1006 1013 +2722 23 1012 1005 1006 1014 +2723 70 1005 1006 1007 1008 +2724 68 1005 1006 1007 1015 +2725 68 1005 1006 1007 1016 +2726 71 1013 1006 1007 1008 +2727 23 1013 1006 1007 1015 +2728 23 1013 1006 1007 1016 +2729 71 1014 1006 1007 1008 +2730 23 1014 1006 1007 1015 +2731 23 1014 1006 1007 1016 +2732 72 1006 1007 1008 1017 +2733 72 1006 1007 1008 1018 +2734 72 1006 1007 1008 1019 +2735 73 1015 1007 1008 1017 +2736 73 1015 1007 1008 1018 +2737 73 1015 1007 1008 1019 +2738 73 1016 1007 1008 1017 +2739 73 1016 1007 1008 1018 +2740 73 1016 1007 1008 1019 +2741 26 1000 1020 1021 1022 +2742 27 1000 1020 1021 1025 +2743 28 1000 1020 1021 1026 +2744 29 1024 1020 1021 1022 +2745 30 1024 1020 1021 1025 +2746 31 1024 1020 1021 1026 +2747 32 1020 1021 1022 1023 +2748 33 1020 1021 1022 1035 +2749 34 1020 1021 1026 1027 +2750 35 1020 1021 1026 1031 +2751 35 1020 1021 1026 1032 +2752 8 1022 1021 1026 1027 +2753 9 1022 1021 1026 1031 +2754 9 1022 1021 1026 1032 +2755 10 1025 1021 1022 1023 +2756 11 1025 1021 1022 1035 +2757 12 1025 1021 1026 1027 +2758 13 1025 1021 1026 1031 +2759 13 1025 1021 1026 1032 +2760 14 1026 1021 1022 1023 +2761 15 1026 1021 1022 1035 +2762 16 1021 1022 1035 1036 +2763 17 1021 1022 1035 1039 +2764 18 1023 1022 1035 1036 +2765 19 1023 1022 1035 1039 +2766 97 1021 1026 1027 1028 +2767 21 1021 1026 1027 1033 +2768 21 1021 1026 1027 1034 +2769 98 1031 1026 1027 1028 +2770 23 1031 1026 1027 1033 +2771 23 1031 1026 1027 1034 +2772 98 1032 1026 1027 1028 +2773 23 1032 1026 1027 1033 +2774 23 1032 1026 1027 1034 +2775 99 1026 1027 1028 1029 +2776 99 1026 1027 1028 1030 +2777 100 1033 1027 1028 1029 +2778 100 1033 1027 1028 1030 +2779 100 1034 1027 1028 1029 +2780 100 1034 1027 1028 1030 +2781 26 1022 1035 1036 1037 +2782 27 1022 1035 1036 1040 +2783 28 1022 1035 1036 1041 +2784 29 1039 1035 1036 1037 +2785 30 1039 1035 1036 1040 +2786 31 1039 1035 1036 1041 +2787 32 1035 1036 1037 1038 +2788 33 1035 1036 1037 1046 +2789 136 1035 1036 1041 1042 +2790 35 1035 1036 1041 1043 +2791 35 1035 1036 1041 1044 +2792 137 1037 1036 1041 1042 +2793 9 1037 1036 1041 1043 +2794 9 1037 1036 1041 1044 +2795 10 1040 1036 1037 1038 +2796 11 1040 1036 1037 1046 +2797 138 1040 1036 1041 1042 +2798 13 1040 1036 1041 1043 +2799 13 1040 1036 1041 1044 +2800 14 1041 1036 1037 1038 +2801 15 1041 1036 1037 1046 +2802 16 1036 1037 1046 1047 +2803 17 1036 1037 1046 1050 +2804 18 1038 1037 1046 1047 +2805 19 1038 1037 1046 1050 +2806 139 1036 1041 1042 1045 +2807 140 1043 1041 1042 1045 +2808 140 1044 1041 1042 1045 +2809 26 1037 1046 1047 1048 +2810 27 1037 1046 1047 1051 +2811 43 1037 1046 1047 1052 +2812 29 1050 1046 1047 1048 +2813 30 1050 1046 1047 1051 +2814 44 1050 1046 1047 1052 +2815 32 1046 1047 1048 1049 +2816 33 1046 1047 1048 1060 +2817 74 1046 1047 1052 1053 +2818 45 1046 1047 1052 1054 +2819 46 1046 1047 1052 1055 +2820 75 1048 1047 1052 1053 +2821 47 1048 1047 1052 1054 +2822 48 1048 1047 1052 1055 +2823 10 1051 1047 1048 1049 +2824 11 1051 1047 1048 1060 +2825 76 1051 1047 1052 1053 +2826 49 1051 1047 1052 1054 +2827 50 1051 1047 1052 1055 +2828 51 1052 1047 1048 1049 +2829 52 1052 1047 1048 1060 +2830 16 1047 1048 1060 1061 +2831 17 1047 1048 1060 1064 +2832 18 1049 1048 1060 1061 +2833 19 1049 1048 1060 1064 +2834 77 1047 1052 1053 1056 +2835 54 1047 1052 1054 1057 +2836 54 1047 1052 1054 1058 +2837 54 1047 1052 1054 1059 +2838 78 1053 1052 1054 1057 +2839 78 1053 1052 1054 1058 +2840 78 1053 1052 1054 1059 +2841 79 1054 1052 1053 1056 +2842 80 1055 1052 1053 1056 +2843 13 1055 1052 1054 1057 +2844 13 1055 1052 1054 1058 +2845 13 1055 1052 1054 1059 +2846 26 1048 1060 1061 1062 +2847 27 1048 1060 1061 1065 +2848 28 1048 1060 1061 1066 +2849 29 1064 1060 1061 1062 +2850 30 1064 1060 1061 1065 +2851 31 1064 1060 1061 1066 +2852 32 1060 1061 1062 1063 +2853 33 1060 1061 1062 1079 +2854 81 1060 1061 1066 1067 +2855 35 1060 1061 1066 1070 +2856 35 1060 1061 1066 1071 +2857 82 1062 1061 1066 1067 +2858 9 1062 1061 1066 1070 +2859 9 1062 1061 1066 1071 +2860 10 1065 1061 1062 1063 +2861 11 1065 1061 1062 1079 +2862 83 1065 1061 1066 1067 +2863 13 1065 1061 1066 1070 +2864 13 1065 1061 1066 1071 +2865 14 1066 1061 1062 1063 +2866 15 1066 1061 1062 1079 +2867 16 1061 1062 1079 1080 +2868 17 1061 1062 1079 1083 +2869 18 1063 1062 1079 1080 +2870 19 1063 1062 1079 1083 +2871 84 1061 1066 1067 1068 +2872 84 1061 1066 1067 1069 +2873 83 1061 1066 1067 1072 +2874 55 1070 1066 1067 1068 +2875 55 1070 1066 1067 1069 +2876 13 1070 1066 1067 1072 +2877 55 1071 1066 1067 1068 +2878 55 1071 1066 1067 1069 +2879 13 1071 1066 1067 1072 +2880 55 1066 1067 1068 1073 +2881 55 1066 1067 1068 1074 +2882 55 1066 1067 1068 1075 +2883 55 1066 1067 1069 1076 +2884 55 1066 1067 1069 1077 +2885 55 1066 1067 1069 1078 +2886 55 1068 1067 1069 1076 +2887 55 1068 1067 1069 1077 +2888 55 1068 1067 1069 1078 +2889 55 1069 1067 1068 1073 +2890 55 1069 1067 1068 1074 +2891 55 1069 1067 1068 1075 +2892 13 1072 1067 1068 1073 +2893 13 1072 1067 1068 1074 +2894 13 1072 1067 1068 1075 +2895 13 1072 1067 1069 1076 +2896 13 1072 1067 1069 1077 +2897 13 1072 1067 1069 1078 +2898 26 1062 1079 1080 1081 +2899 27 1062 1079 1080 1084 +2900 28 1062 1079 1080 1085 +2901 29 1083 1079 1080 1081 +2902 30 1083 1079 1080 1084 +2903 31 1083 1079 1080 1085 +2904 32 1079 1080 1081 1082 +2905 33 1079 1080 1081 1097 +2906 164 1079 1080 1085 1086 +2907 35 1079 1080 1085 1091 +2908 35 1079 1080 1085 1092 +2909 165 1081 1080 1085 1086 +2910 9 1081 1080 1085 1091 +2911 9 1081 1080 1085 1092 +2912 10 1084 1080 1081 1082 +2913 11 1084 1080 1081 1097 +2914 166 1084 1080 1085 1086 +2915 13 1084 1080 1085 1091 +2916 13 1084 1080 1085 1092 +2917 14 1085 1080 1081 1082 +2918 15 1085 1080 1081 1097 +2919 16 1080 1081 1097 1098 +2920 17 1080 1081 1097 1101 +2921 18 1082 1081 1097 1098 +2922 19 1082 1081 1097 1101 +2923 167 1080 1085 1086 1087 +2924 168 1080 1085 1086 1088 +2925 169 1091 1085 1086 1087 +2926 170 1091 1085 1086 1088 +2927 169 1092 1085 1086 1087 +2928 170 1092 1085 1086 1088 +2929 171 1085 1086 1087 1089 +2930 172 1085 1086 1087 1093 +2931 173 1085 1086 1088 1090 +2932 174 1085 1086 1088 1094 +2933 175 1087 1086 1088 1090 +2934 176 1087 1086 1088 1094 +2935 177 1088 1086 1087 1089 +2936 178 1088 1086 1087 1093 +2937 179 1086 1087 1089 1090 +2938 180 1086 1087 1089 1095 +2939 181 1093 1087 1089 1090 +2940 182 1093 1087 1089 1095 +2941 177 1086 1088 1090 1089 +2942 178 1086 1088 1090 1096 +2943 183 1094 1088 1090 1089 +2944 184 1094 1088 1090 1096 +2945 179 1087 1089 1090 1088 +2946 181 1087 1089 1090 1096 +2947 180 1095 1089 1090 1088 +2948 182 1095 1089 1090 1096 +2949 26 1081 1097 1098 1099 +2950 27 1081 1097 1098 1102 +2951 28 1081 1097 1098 1103 +2952 29 1101 1097 1098 1099 +2953 30 1101 1097 1098 1102 +2954 31 1101 1097 1098 1103 +2955 32 1097 1098 1099 1100 +2956 33 1097 1098 1099 1116 +2957 81 1097 1098 1103 1104 +2958 35 1097 1098 1103 1107 +2959 35 1097 1098 1103 1108 +2960 82 1099 1098 1103 1104 +2961 9 1099 1098 1103 1107 +2962 9 1099 1098 1103 1108 +2963 10 1102 1098 1099 1100 +2964 11 1102 1098 1099 1116 +2965 83 1102 1098 1103 1104 +2966 13 1102 1098 1103 1107 +2967 13 1102 1098 1103 1108 +2968 14 1103 1098 1099 1100 +2969 15 1103 1098 1099 1116 +2970 16 1098 1099 1116 1117 +2971 17 1098 1099 1116 1120 +2972 18 1100 1099 1116 1117 +2973 19 1100 1099 1116 1120 +2974 84 1098 1103 1104 1105 +2975 84 1098 1103 1104 1106 +2976 83 1098 1103 1104 1109 +2977 55 1107 1103 1104 1105 +2978 55 1107 1103 1104 1106 +2979 13 1107 1103 1104 1109 +2980 55 1108 1103 1104 1105 +2981 55 1108 1103 1104 1106 +2982 13 1108 1103 1104 1109 +2983 55 1103 1104 1105 1110 +2984 55 1103 1104 1105 1111 +2985 55 1103 1104 1105 1112 +2986 55 1103 1104 1106 1113 +2987 55 1103 1104 1106 1114 +2988 55 1103 1104 1106 1115 +2989 55 1105 1104 1106 1113 +2990 55 1105 1104 1106 1114 +2991 55 1105 1104 1106 1115 +2992 55 1106 1104 1105 1110 +2993 55 1106 1104 1105 1111 +2994 55 1106 1104 1105 1112 +2995 13 1109 1104 1105 1110 +2996 13 1109 1104 1105 1111 +2997 13 1109 1104 1105 1112 +2998 13 1109 1104 1106 1113 +2999 13 1109 1104 1106 1114 +3000 13 1109 1104 1106 1115 +3001 26 1099 1116 1117 1118 +3002 27 1099 1116 1117 1121 +3003 43 1099 1116 1117 1122 +3004 29 1120 1116 1117 1118 +3005 30 1120 1116 1117 1121 +3006 44 1120 1116 1117 1122 +3007 32 1116 1117 1118 1119 +3008 33 1116 1117 1118 1132 +3009 45 1116 1117 1122 1123 +3010 45 1116 1117 1122 1124 +3011 46 1116 1117 1122 1125 +3012 47 1118 1117 1122 1123 +3013 47 1118 1117 1122 1124 +3014 48 1118 1117 1122 1125 +3015 10 1121 1117 1118 1119 +3016 11 1121 1117 1118 1132 +3017 49 1121 1117 1122 1123 +3018 49 1121 1117 1122 1124 +3019 50 1121 1117 1122 1125 +3020 51 1122 1117 1118 1119 +3021 52 1122 1117 1118 1132 +3022 16 1117 1118 1132 1133 +3023 17 1117 1118 1132 1136 +3024 18 1119 1118 1132 1133 +3025 19 1119 1118 1132 1136 +3026 54 1117 1122 1123 1126 +3027 54 1117 1122 1123 1127 +3028 54 1117 1122 1123 1128 +3029 54 1117 1122 1124 1129 +3030 54 1117 1122 1124 1130 +3031 54 1117 1122 1124 1131 +3032 55 1123 1122 1124 1129 +3033 55 1123 1122 1124 1130 +3034 55 1123 1122 1124 1131 +3035 55 1124 1122 1123 1126 +3036 55 1124 1122 1123 1127 +3037 55 1124 1122 1123 1128 +3038 13 1125 1122 1123 1126 +3039 13 1125 1122 1123 1127 +3040 13 1125 1122 1123 1128 +3041 13 1125 1122 1124 1129 +3042 13 1125 1122 1124 1130 +3043 13 1125 1122 1124 1131 +3044 26 1118 1132 1133 1134 +3045 27 1118 1132 1133 1137 +3046 28 1118 1132 1133 1138 +3047 29 1136 1132 1133 1134 +3048 30 1136 1132 1133 1137 +3049 31 1136 1132 1133 1138 +3050 32 1132 1133 1134 1135 +3051 33 1132 1133 1134 1151 +3052 81 1132 1133 1138 1139 +3053 35 1132 1133 1138 1142 +3054 35 1132 1133 1138 1143 +3055 82 1134 1133 1138 1139 +3056 9 1134 1133 1138 1142 +3057 9 1134 1133 1138 1143 +3058 10 1137 1133 1134 1135 +3059 11 1137 1133 1134 1151 +3060 83 1137 1133 1138 1139 +3061 13 1137 1133 1138 1142 +3062 13 1137 1133 1138 1143 +3063 14 1138 1133 1134 1135 +3064 15 1138 1133 1134 1151 +3065 16 1133 1134 1151 1152 +3066 17 1133 1134 1151 1155 +3067 18 1135 1134 1151 1152 +3068 19 1135 1134 1151 1155 +3069 84 1133 1138 1139 1140 +3070 84 1133 1138 1139 1141 +3071 83 1133 1138 1139 1144 +3072 55 1142 1138 1139 1140 +3073 55 1142 1138 1139 1141 +3074 13 1142 1138 1139 1144 +3075 55 1143 1138 1139 1140 +3076 55 1143 1138 1139 1141 +3077 13 1143 1138 1139 1144 +3078 55 1138 1139 1140 1145 +3079 55 1138 1139 1140 1146 +3080 55 1138 1139 1140 1147 +3081 55 1138 1139 1141 1148 +3082 55 1138 1139 1141 1149 +3083 55 1138 1139 1141 1150 +3084 55 1140 1139 1141 1148 +3085 55 1140 1139 1141 1149 +3086 55 1140 1139 1141 1150 +3087 55 1141 1139 1140 1145 +3088 55 1141 1139 1140 1146 +3089 55 1141 1139 1140 1147 +3090 13 1144 1139 1140 1145 +3091 13 1144 1139 1140 1146 +3092 13 1144 1139 1140 1147 +3093 13 1144 1139 1141 1148 +3094 13 1144 1139 1141 1149 +3095 13 1144 1139 1141 1150 +3096 26 1134 1151 1152 1153 +3097 27 1134 1151 1152 1156 +3098 28 1134 1151 1152 1157 +3099 29 1155 1151 1152 1153 +3100 30 1155 1151 1152 1156 +3101 31 1155 1151 1152 1157 +3102 32 1151 1152 1153 1154 +3103 33 1151 1152 1153 1175 +3104 34 1151 1152 1157 1158 +3105 35 1151 1152 1157 1164 +3106 35 1151 1152 1157 1165 +3107 8 1153 1152 1157 1158 +3108 9 1153 1152 1157 1164 +3109 9 1153 1152 1157 1165 +3110 10 1156 1152 1153 1154 +3111 11 1156 1152 1153 1175 +3112 12 1156 1152 1157 1158 +3113 13 1156 1152 1157 1164 +3114 13 1156 1152 1157 1165 +3115 14 1157 1152 1153 1154 +3116 15 1157 1152 1153 1175 +3117 16 1152 1153 1175 1176 +3118 17 1152 1153 1175 1179 +3119 18 1154 1153 1175 1176 +3120 19 1154 1153 1175 1179 +3121 67 1152 1157 1158 1159 +3122 21 1152 1157 1158 1166 +3123 21 1152 1157 1158 1167 +3124 68 1164 1157 1158 1159 +3125 23 1164 1157 1158 1166 +3126 23 1164 1157 1158 1167 +3127 68 1165 1157 1158 1159 +3128 23 1165 1157 1158 1166 +3129 23 1165 1157 1158 1167 +3130 153 1157 1158 1159 1160 +3131 68 1157 1158 1159 1168 +3132 68 1157 1158 1159 1169 +3133 154 1166 1158 1159 1160 +3134 23 1166 1158 1159 1168 +3135 23 1166 1158 1159 1169 +3136 154 1167 1158 1159 1160 +3137 23 1167 1158 1159 1168 +3138 23 1167 1158 1159 1169 +3139 155 1158 1159 1160 1161 +3140 156 1158 1159 1160 1170 +3141 157 1168 1159 1160 1161 +3142 158 1168 1159 1160 1170 +3143 157 1169 1159 1160 1161 +3144 158 1169 1159 1160 1170 +3145 159 1159 1160 1161 1162 +3146 159 1159 1160 1161 1163 +3147 160 1170 1160 1161 1162 +3148 160 1170 1160 1161 1163 +3149 160 1160 1161 1162 1171 +3150 160 1160 1161 1162 1172 +3151 160 1160 1161 1163 1173 +3152 160 1160 1161 1163 1174 +3153 160 1162 1161 1163 1173 +3154 160 1162 1161 1163 1174 +3155 160 1163 1161 1162 1171 +3156 160 1163 1161 1162 1172 +3157 26 1153 1175 1176 1177 +3158 27 1153 1175 1176 1180 +3159 28 1153 1175 1176 1181 +3160 29 1179 1175 1176 1177 +3161 30 1179 1175 1176 1180 +3162 31 1179 1175 1176 1181 +3163 32 1175 1176 1177 1178 +3164 33 1175 1176 1177 1194 +3165 81 1175 1176 1181 1182 +3166 35 1175 1176 1181 1185 +3167 35 1175 1176 1181 1186 +3168 82 1177 1176 1181 1182 +3169 9 1177 1176 1181 1185 +3170 9 1177 1176 1181 1186 +3171 10 1180 1176 1177 1178 +3172 11 1180 1176 1177 1194 +3173 83 1180 1176 1181 1182 +3174 13 1180 1176 1181 1185 +3175 13 1180 1176 1181 1186 +3176 14 1181 1176 1177 1178 +3177 15 1181 1176 1177 1194 +3178 16 1176 1177 1194 1195 +3179 17 1176 1177 1194 1198 +3180 18 1178 1177 1194 1195 +3181 19 1178 1177 1194 1198 +3182 84 1176 1181 1182 1183 +3183 84 1176 1181 1182 1184 +3184 83 1176 1181 1182 1187 +3185 55 1185 1181 1182 1183 +3186 55 1185 1181 1182 1184 +3187 13 1185 1181 1182 1187 +3188 55 1186 1181 1182 1183 +3189 55 1186 1181 1182 1184 +3190 13 1186 1181 1182 1187 +3191 55 1181 1182 1183 1188 +3192 55 1181 1182 1183 1189 +3193 55 1181 1182 1183 1190 +3194 55 1181 1182 1184 1191 +3195 55 1181 1182 1184 1192 +3196 55 1181 1182 1184 1193 +3197 55 1183 1182 1184 1191 +3198 55 1183 1182 1184 1192 +3199 55 1183 1182 1184 1193 +3200 55 1184 1182 1183 1188 +3201 55 1184 1182 1183 1189 +3202 55 1184 1182 1183 1190 +3203 13 1187 1182 1183 1188 +3204 13 1187 1182 1183 1189 +3205 13 1187 1182 1183 1190 +3206 13 1187 1182 1184 1191 +3207 13 1187 1182 1184 1192 +3208 13 1187 1182 1184 1193 +3209 26 1177 1194 1195 1196 +3210 27 1177 1194 1195 1199 +3211 28 1177 1194 1195 1200 +3212 29 1198 1194 1195 1196 +3213 30 1198 1194 1195 1199 +3214 31 1198 1194 1195 1200 +3215 32 1194 1195 1196 1197 +3216 33 1194 1195 1196 1218 +3217 34 1194 1195 1200 1201 +3218 35 1194 1195 1200 1207 +3219 35 1194 1195 1200 1208 +3220 8 1196 1195 1200 1201 +3221 9 1196 1195 1200 1207 +3222 9 1196 1195 1200 1208 +3223 10 1199 1195 1196 1197 +3224 11 1199 1195 1196 1218 +3225 12 1199 1195 1200 1201 +3226 13 1199 1195 1200 1207 +3227 13 1199 1195 1200 1208 +3228 14 1200 1195 1196 1197 +3229 15 1200 1195 1196 1218 +3230 85 1195 1196 1218 1219 +3231 17 1195 1196 1218 1222 +3232 86 1197 1196 1218 1219 +3233 19 1197 1196 1218 1222 +3234 67 1195 1200 1201 1202 +3235 21 1195 1200 1201 1209 +3236 21 1195 1200 1201 1210 +3237 68 1207 1200 1201 1202 +3238 23 1207 1200 1201 1209 +3239 23 1207 1200 1201 1210 +3240 68 1208 1200 1201 1202 +3241 23 1208 1200 1201 1209 +3242 23 1208 1200 1201 1210 +3243 153 1200 1201 1202 1203 +3244 68 1200 1201 1202 1211 +3245 68 1200 1201 1202 1212 +3246 154 1209 1201 1202 1203 +3247 23 1209 1201 1202 1211 +3248 23 1209 1201 1202 1212 +3249 154 1210 1201 1202 1203 +3250 23 1210 1201 1202 1211 +3251 23 1210 1201 1202 1212 +3252 155 1201 1202 1203 1204 +3253 156 1201 1202 1203 1213 +3254 157 1211 1202 1203 1204 +3255 158 1211 1202 1203 1213 +3256 157 1212 1202 1203 1204 +3257 158 1212 1202 1203 1213 +3258 159 1202 1203 1204 1205 +3259 159 1202 1203 1204 1206 +3260 160 1213 1203 1204 1205 +3261 160 1213 1203 1204 1206 +3262 160 1203 1204 1205 1214 +3263 160 1203 1204 1205 1215 +3264 160 1203 1204 1206 1216 +3265 160 1203 1204 1206 1217 +3266 160 1205 1204 1206 1216 +3267 160 1205 1204 1206 1217 +3268 160 1206 1204 1205 1214 +3269 160 1206 1204 1205 1215 +3270 87 1196 1218 1219 1220 +3271 88 1196 1218 1219 1223 +3272 88 1196 1218 1219 1224 +3273 89 1222 1218 1219 1220 +3274 90 1222 1218 1219 1223 +3275 90 1222 1218 1219 1224 +3276 91 1218 1219 1220 1221 +3277 92 1218 1219 1220 1225 +3278 93 1223 1219 1220 1221 +3279 94 1223 1219 1220 1225 +3280 93 1224 1219 1220 1221 +3281 94 1224 1219 1220 1225 +3282 185 1219 1220 1225 1226 +3283 96 1219 1220 1225 1229 +3284 86 1221 1220 1225 1226 +3285 19 1221 1220 1225 1229 +3286 186 1220 1225 1226 1227 +3287 88 1220 1225 1226 1230 +3288 88 1220 1225 1226 1231 +3289 187 1229 1225 1226 1227 +3290 90 1229 1225 1226 1230 +3291 90 1229 1225 1226 1231 +3292 188 1225 1226 1227 1228 +3293 188 1225 1226 1227 1232 +3294 189 1230 1226 1227 1228 +3295 189 1230 1226 1227 1232 +3296 189 1231 1226 1227 1228 +3297 189 1231 1226 1227 1232 + Bond Coeffs 1 1.448 381.3 -972.315 1446.3185625 @@ -21831,14 +25133,14 @@ Angle Coeffs 9 1 122.4 80.0 -64.1712730547 14.7069724481 -10.5330931336 18.9671988558 10 1 113.4 70.0 -56.1498639228 12.868600892 -9.21645649191 16.5962989988 11 1 124.2 77.0 -61.7648503151 14.1554609813 -10.1381021411 18.2559288987 -12 2 111.0 48.2 -38.6631920154 8.86095089995 -6.346188613 11.4277373106 +12 0 111.0 48.2 -38.6631920154 8.86095089995 -6.346188613 11.4277373106 13 0 110.7 42.0 -33.6899183537 7.72116053523 -5.52987389514 9.95777939927 14 0 110.7 42.0 -33.6899183537 7.72116053523 -5.52987389514 9.95777939927 15 0 107.8 40.0 -32.0856365273 7.35348622403 -5.2665465668 9.48359942788 -16 2 110.1 53.2 -42.6738965813 9.78013667795 -7.00450693385 12.6131872391 -17 2 110.8 53.2 -42.6738965813 9.78013667795 -7.00450693385 12.6131872391 +16 0 110.1 53.2 -42.6738965813 9.78013667795 -7.00450693385 12.6131872391 +17 0 110.8 53.2 -42.6738965813 9.78013667795 -7.00450693385 12.6131872391 18 0 95.9 60.4 -48.4493111563 11.1037641983 -7.95248531587 14.3202351361 -19 2 108.0 53.2 -42.6738965813 9.78013667795 -7.00450693385 12.6131872391 +19 0 108.0 53.2 -42.6738965813 9.78013667795 -7.00450693385 12.6131872391 20 1 122.0 50.0 -40.1070456592 9.19185778003 -6.5831832085 11.8544992848 21 1 121.0 36.0 -28.8770728746 6.61813760162 -4.73989191012 8.53523948509 22 1 117.0 32.0 -25.6685092219 5.88278897922 -4.21323725344 7.5868795423 @@ -21853,23 +25155,23 @@ Angle Coeffs 31 0 111.3 54.0 -43.3156093119 9.92720640244 -7.10983786519 12.8028592276 32 0 110.6 58.0 -46.5241729646 10.6625550248 -7.63649252187 13.7512191704 33 0 110.7 42.0 -33.6899183537 7.72116053523 -5.52987389514 9.95777939927 -34 2 110.2 48.2 -38.6631920154 8.86095089995 -6.346188613 11.4277373106 -35 2 110.2 48.2 -38.6631920154 8.86095089995 -6.346188613 11.4277373106 +34 0 110.2 48.2 -38.6631920154 8.86095089995 -6.346188613 11.4277373106 +35 0 110.2 48.2 -38.6631920154 8.86095089995 -6.346188613 11.4277373106 36 0 110.6 38.9 -31.2032815228 7.15126535287 -5.12171653622 9.22280044361 -37 2 109.3 39.6 -31.7647801621 7.27995136179 -5.21388110114 9.3887634336 +37 0 109.3 39.6 -31.7647801621 7.27995136179 -5.21388110114 9.3887634336 38 1 122.3 33.8 -27.1123628656 6.2136958593 -4.45023184895 8.01364151656 39 1 121.7 54.7 -43.8771079511 10.0558924114 -7.2020024301 12.9688222176 -40 2 120.0 35.3 -28.3155742354 6.4894515927 -4.6477273452 8.3692764951 -41 2 111.0 48.2 -38.6631920154 8.86095089995 -6.346188613 11.4277373106 +40 1 120.0 35.3 -28.3155742354 6.4894515927 -4.6477273452 8.3692764951 +41 0 111.0 48.2 -38.6631920154 8.86095089995 -6.346188613 11.4277373106 42 0 109.5 56.1 -45.0001052296 10.3132644292 -7.38633155994 13.3007481976 43 0 109.3 59.0 -47.3263138778 10.8463921804 -7.76815618604 13.9883091561 44 0 110.9 43.2 -34.6524874495 7.94176512195 -5.68787029215 10.2422873821 45 0 107.0 43.5 -34.8931297235 7.99691626863 -5.7273693914 10.3134143778 46 0 107.5 59.7 -47.887812517 10.9750781894 -7.86032075095 14.1542721461 47 0 107.5 59.7 -47.887812517 10.9750781894 -7.86032075095 14.1542721461 -48 2 110.0 59.0 -47.3263138778 10.8463921804 -7.76815618604 13.9883091561 +48 0 110.0 59.0 -47.3263138778 10.8463921804 -7.76815618604 13.9883091561 49 0 106.8 54.0 -43.3156093119 9.92720640244 -7.10983786519 12.8028592276 -50 2 111.0 48.2 -38.6631920154 8.86095089995 -6.346188613 11.4277373106 +50 0 111.0 48.2 -38.6631920154 8.86095089995 -6.346188613 11.4277373106 51 1 122.0 50.0 -40.1070456592 9.19185778003 -6.5831832085 11.8544992848 52 1 117.0 32.0 -25.6685092219 5.88278897922 -4.21323725344 7.5868795423 53 0 109.8 55.0 -44.1177502251 10.111043558 -7.24150152936 13.0399492133 @@ -21902,7 +25204,7 @@ Angle Coeffs 80 0 110.7 42.0 -33.6899183537 7.72116053523 -5.52987389514 9.95777939927 81 0 107.8 40.0 -32.0856365273 7.35348622403 -5.2665465668 9.48359942788 82 0 107.5 59.7 -47.887812517 10.9750781894 -7.86032075095 14.1542721461 -83 2 108.9 59.0 -47.3263138778 10.8463921804 -7.76815618604 13.9883091561 +83 0 108.9 59.0 -47.3263138778 10.8463921804 -7.76815618604 13.9883091561 84 0 106.8 54.0 -43.3156093119 9.92720640244 -7.10983786519 12.8028592276 85 0 110.6 47.6 -38.1819074675 8.75064860659 -6.2671904145 11.2854833192 86 0 110.6 47.6 -38.1819074675 8.75064860659 -6.2671904145 11.2854833192 @@ -21932,6 +25234,198 @@ Angle Coeffs 110 1 122.4 80.0 -64.1712730547 14.7069724481 -10.5330931336 18.9671988558 111 0 108.5 48.7 -39.064262472 8.95286947775 -6.41202044508 11.5462823034 +Dihedral Coeffs + +1 3 0.6195 1 0.0 -0.2025 2 180.0 0.0175 3 0.0 +2 3 0.0 1 0.0 -0.0405 2 180.0 0.185 3 0.0 +3 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 +4 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 +5 3 -0.1985 1 0.0 1.098 2 180.0 -0.1855 3 0.0 +6 3 0.061 1 0.0 0.0455 2 180.0 0.012 3 0.0 +7 3 0.0 1 0.0 0.0 2 180.0 0.25 3 0.0 +8 3 1.2615 1 0.0 0.4655 2 180.0 -0.205 3 0.0 +9 3 0.0 1 0.0 0.0 2 180.0 0.09 3 0.0 +10 3 0.0 1 0.0 0.0 2 180.0 0.1175 3 0.0 +11 3 0.0 1 0.0 0.0 2 180.0 -0.005 3 0.0 +12 3 0.0 1 0.0 0.0 2 180.0 0.1705 3 0.0 +13 3 0.0 1 0.0 0.0 2 180.0 0.1495 3 0.0 +14 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 +15 3 0.2235 1 0.0 0.8535 2 180.0 -0.671 3 0.0 +16 3 -0.5 1 0.0 1.0 2 180.0 1.0 3 0.0 +17 3 0.0 1 0.0 0.5 2 180.0 0.4 3 0.0 +18 3 0.5 1 0.0 1.125 2 180.0 -1.125 3 0.0 +19 3 0.0 1 0.0 0.5 2 180.0 -0.275 3 0.0 +20 3 0.125 1 0.0 0.08 2 180.0 -0.9025 3 0.0 +21 3 0.0 1 0.0 0.0 2 180.0 0.1705 3 0.0 +22 3 0.0 1 0.0 0.0 2 180.0 0.2375 3 0.0 +23 3 0.0 1 0.0 0.0 2 180.0 0.1495 3 0.0 +24 3 -0.5305 1 0.0 0.066 2 180.0 0.165 3 0.0 +25 3 0.0 1 0.0 0.0 2 180.0 0.33 3 0.0 +26 3 0.397 1 0.0 -0.3195 2 180.0 0.36 3 0.0 +27 3 0.0 1 0.0 0.0 2 180.0 -0.063 3 0.0 +28 3 0.9995 1 0.0 0.0105 2 180.0 0.0 3 0.0 +29 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 +30 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 +31 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 +32 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 +33 3 -0.844 1 0.0 2.1245 2 180.0 0.0 3 0.0 +34 3 0.185 1 0.0 0.297 2 180.0 -0.113 3 0.0 +35 3 0.0 1 0.0 0.0 2 180.0 0.25 3 0.0 +36 3 -0.1285 1 0.0 -0.11 2 180.0 0.0 3 0.0 +37 3 0.0 1 0.0 0.0 2 180.0 0.09 3 0.0 +38 3 0.227 1 0.0 0.04 2 180.0 -0.155 3 0.0 +39 3 -0.2375 1 0.0 0.3875 2 180.0 0.021 3 0.0 +40 3 -0.077 1 0.0 0.022 2 180.0 -0.043 3 0.0 +41 3 0.0 1 0.0 0.0 2 180.0 0.115 3 0.0 +42 3 0.0 1 0.0 0.5 2 180.0 0.4 3 0.0 +43 3 0.9995 1 0.0 0.0105 2 180.0 0.0 3 0.0 +44 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 +45 3 0.387 1 0.0 -0.843 2 180.0 0.0 3 0.0 +46 3 0.0 1 0.0 0.0 2 180.0 0.25 3 0.0 +47 3 0.6715 1 0.0 0.0675 2 180.0 0.0 3 0.0 +48 3 0.0 1 0.0 0.0 2 180.0 0.09 3 0.0 +49 3 0.0 1 0.0 0.0 2 180.0 0.1705 3 0.0 +50 3 0.0 1 0.0 0.0 2 180.0 0.1495 3 0.0 +51 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 +52 3 0.2235 1 0.0 0.8535 2 180.0 -0.671 3 0.0 +53 3 0.428 1 0.0 0.4205 2 180.0 -0.187 3 0.0 +54 3 0.0 1 0.0 0.0 2 180.0 0.0455 3 0.0 +55 3 0.0 1 0.0 0.0 2 180.0 0.1705 3 0.0 +56 3 -0.3155 1 0.0 0.5335 2 180.0 -0.3515 3 0.0 +57 3 -1.142 1 0.0 0.67 2 180.0 0.0 3 0.0 +58 3 -1.6145 1 0.0 0.294 2 180.0 0.0 3 0.0 +59 3 0.0 1 0.0 0.0 2 180.0 0.25 3 0.0 +60 3 -0.2475 1 0.0 0.36 2 180.0 -0.242 3 0.0 +61 3 0.0 1 0.0 0.0 2 180.0 -0.045 3 0.0 +62 3 -0.305 1 0.0 2.106 2 180.0 0.0 3 0.0 +63 3 0.0 1 0.0 2.052 2 180.0 0.0 3 0.0 +64 3 -0.335 1 0.0 2.002 2 180.0 0.0 3 0.0 +65 3 0.275 1 0.0 2.267 2 180.0 -0.275 3 0.0 +66 3 0.0 1 0.0 2.036 2 180.0 0.0 3 0.0 +67 3 0.076 1 0.0 -0.1155 2 180.0 0.189 3 0.0 +68 3 0.0 1 0.0 0.0 2 180.0 0.1705 3 0.0 +69 3 0.076 1 0.0 -0.1155 2 180.0 0.189 3 0.0 +70 3 0.0 1 0.0 0.032 2 180.0 0.3025 3 0.0 +71 3 0.0 1 0.0 0.0 2 180.0 0.187 3 0.0 +72 3 0.0 1 0.0 0.0 2 180.0 -0.055 3 0.0 +73 3 0.0 1 0.0 -0.0405 2 180.0 0.185 3 0.0 +74 3 -0.547 1 0.0 0.3105 2 180.0 0.009 3 0.0 +75 3 -0.269 1 0.0 0.3515 2 180.0 -0.083 3 0.0 +76 3 0.0 1 0.0 0.0 2 180.0 0.1705 3 0.0 +77 3 -0.686 1 0.0 0.116 2 180.0 0.2 3 0.0 +78 3 0.0 1 0.0 0.0 2 180.0 0.1705 3 0.0 +79 3 -0.686 1 0.0 0.116 2 180.0 0.2 3 0.0 +80 3 0.0 1 0.0 0.0 2 180.0 0.133 3 0.0 +81 3 -0.4495 1 0.0 0.539 2 180.0 -0.1705 3 0.0 +82 3 0.574 1 0.0 -0.1445 2 180.0 -0.2785 3 0.0 +83 3 0.0 1 0.0 0.0 2 180.0 0.1705 3 0.0 +84 3 -0.3155 1 0.0 0.5335 2 180.0 -0.3515 3 0.0 +85 3 -0.5 1 0.0 1.0 2 180.0 1.0 3 0.0 +86 3 0.5 1 0.0 1.125 2 180.0 -1.125 3 0.0 +87 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 +88 3 0.0 1 0.0 0.0 2 180.0 -0.063 3 0.0 +89 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 +90 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 +91 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 +92 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 +93 3 0.0 1 0.0 0.0 2 180.0 0.1175 3 0.0 +94 3 0.0 1 0.0 0.0 2 180.0 -0.005 3 0.0 +95 3 -0.5 1 0.0 1.0 2 180.0 1.0 3 0.0 +96 3 0.0 1 0.0 0.5 2 180.0 0.4 3 0.0 +97 3 -2.1285 1 0.0 -0.11 2 180.0 0.0 3 0.0 +98 3 0.0 1 0.0 0.0 2 180.0 0.09 3 0.0 +99 3 0.0 1 0.0 0.05 2 180.0 0.0 3 0.0 +100 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 +101 3 -0.902 1 0.0 1.806 2 180.0 -0.098 3 0.0 +102 3 0.0 1 0.0 0.0 2 180.0 -0.005 3 0.0 +103 3 0.1775 1 0.0 0.739 2 180.0 -0.448 3 0.0 +104 3 -0.5 1 0.0 1.0 2 180.0 1.0 3 0.0 +105 3 -0.5 1 0.0 1.0 2 180.0 1.0 3 0.0 +106 3 0.5 1 0.0 1.125 2 180.0 -1.125 3 0.0 +107 3 0.5 1 0.0 1.125 2 180.0 -1.125 3 0.0 +108 3 -0.12 1 0.0 -1.543 2 180.0 -0.9145 3 0.0 +109 3 0.0 1 0.0 0.0 2 180.0 -0.063 3 0.0 +110 3 1.5445 1 0.0 2.688 2 180.0 -0.9145 3 0.0 +111 3 1.108 1 0.0 0.1075 2 180.0 0.405 3 0.0 +112 3 0.0 1 0.0 0.0 2 180.0 -0.063 3 0.0 +113 3 1.108 1 0.0 0.1075 2 180.0 0.405 3 0.0 +114 3 0.0 1 0.0 0.0 2 180.0 -0.063 3 0.0 +115 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 +116 3 0.0 1 0.0 0.0 2 180.0 -0.063 3 0.0 +117 3 1.108 1 0.0 0.1075 2 180.0 0.405 3 0.0 +118 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 +119 3 -1.059 1 0.0 0.5865 2 180.0 0.0 3 0.0 +120 3 -0.1005 1 0.0 0.3435 2 180.0 0.0 3 0.0 +121 3 0.0 1 0.0 0.0 2 180.0 0.25 3 0.0 +122 3 -0.464 1 0.0 0.5135 2 180.0 0.0 3 0.0 +123 3 0.0 1 0.0 0.0 2 180.0 0.09 3 0.0 +124 3 0.0 1 0.0 0.0 2 180.0 0.1705 3 0.0 +125 3 0.0 1 0.0 0.0 2 180.0 0.1495 3 0.0 +126 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 +127 3 1.1125 1 0.0 -0.626 2 180.0 -0.5335 3 0.0 +128 3 0.076 1 0.0 -0.1155 2 180.0 0.189 3 0.0 +129 3 0.0 1 0.0 0.0 2 180.0 0.1705 3 0.0 +130 3 0.0 1 0.0 0.0 2 180.0 0.1705 3 0.0 +131 3 0.0 1 0.0 0.0 2 180.0 0.1495 3 0.0 +132 3 -0.1005 1 0.0 0.3435 2 180.0 0.0 3 0.0 +133 3 0.0 1 0.0 0.0 2 180.0 0.1705 3 0.0 +134 3 0.0 1 0.0 0.0 2 180.0 0.25 3 0.0 +135 3 0.0 1 0.0 0.0 2 180.0 0.1495 3 0.0 +136 3 0.096 1 0.0 -0.0575 2 180.0 -0.1545 3 0.0 +137 3 -0.832 1 0.0 -0.2655 2 180.0 0.0 3 0.0 +138 3 0.0 1 0.0 0.0 2 180.0 0.1705 3 0.0 +139 3 0.635 1 0.0 -0.5115 2 180.0 -0.3635 3 0.0 +140 3 0.0 1 0.0 0.0 2 180.0 0.137 3 0.0 +141 3 0.0825 1 0.0 0.7 2 180.0 0.0 3 0.0 +142 3 -0.589 1 0.0 0.5275 2 180.0 0.0 3 0.0 +143 3 0.0 1 0.0 0.0 2 180.0 0.09 3 0.0 +144 3 0.0 1 0.0 0.5195 2 180.0 0.0 3 0.0 +145 3 -0.254 1 0.0 -0.1065 2 180.0 -0.1685 3 0.0 +146 3 -1.5315 1 0.0 -0.476 2 180.0 0.199 3 0.0 +147 3 0.0 1 0.0 0.0 2 180.0 0.09 3 0.0 +148 3 0.5455 1 0.0 0.224 2 180.0 0.298 3 0.0 +149 3 0.1405 1 0.0 0.332 2 180.0 -0.4235 3 0.0 +150 3 0.1775 1 0.0 0.739 2 180.0 -0.448 3 0.0 +151 3 -1.059 1 0.0 0.5865 2 180.0 0.0 3 0.0 +152 3 1.1125 1 0.0 -0.626 2 180.0 -0.5335 3 0.0 +153 3 -0.2675 1 0.0 -0.055 2 180.0 -0.0365 3 0.0 +154 3 0.0 1 0.0 0.0 2 180.0 0.187 3 0.0 +155 3 0.491 1 0.0 0.497 2 180.0 0.085 3 0.0 +156 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 +157 3 0.0 1 0.0 0.0 2 180.0 -0.063 3 0.0 +158 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 +159 3 0.0 1 0.0 2.25 2 180.0 0.0 3 0.0 +160 3 0.0 1 0.0 2.0 2 180.0 0.0 3 0.0 +161 3 0.0 1 0.0 2.235 2 180.0 0.0 3 0.0 +162 3 0.0 1 0.0 2.235 2 180.0 0.0 3 0.0 +163 3 0.0 1 0.0 1.0405 2 180.0 0.0 3 0.0 +164 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 +165 3 0.0695 1 0.0 -0.407 2 180.0 0.0 3 0.0 +166 3 0.0 1 0.0 0.0 2 180.0 0.25 3 0.0 +167 3 -0.9105 1 0.0 -1.2185 2 180.0 1.0295 3 0.0 +168 3 0.547 1 0.0 -0.08 2 180.0 0.2515 3 0.0 +169 3 0.0 1 0.0 0.0 2 180.0 0.1495 3 0.0 +170 3 0.0 1 0.0 0.0 2 180.0 0.1495 3 0.0 +171 3 0.0 1 0.0 2.106 2 180.0 0.0 3 0.0 +172 3 0.0 1 0.0 2.052 2 180.0 0.0 3 0.0 +173 3 0.0 1 0.0 2.106 2 180.0 0.0 3 0.0 +174 3 0.0 1 0.0 2.051 2 180.0 0.0 3 0.0 +175 3 0.45 1 0.0 4.0 2 180.0 0.0 3 0.0 +176 3 0.3775 1 0.0 1.5 2 180.0 0.0 3 0.0 +177 3 0.0 1 0.0 3.0 2 180.0 0.0 3 0.0 +178 3 -1.575 1 0.0 1.5 2 180.0 0.0 3 0.0 +179 3 0.0 1 0.0 4.0 2 180.0 0.0 3 0.0 +180 3 0.0 1 0.0 1.5 2 180.0 0.0 3 0.0 +181 3 -1.372 1 0.0 1.5 2 180.0 0.0 3 0.0 +182 3 -0.265 1 0.0 1.5 2 180.0 0.0 3 0.0 +183 3 0.0 1 0.0 1.5 2 180.0 0.0 3 0.0 +184 3 -0.265 1 0.0 1.5 2 180.0 0.0 3 0.0 +185 3 -0.5 1 0.0 1.0 2 180.0 1.0 3 0.0 +186 3 -0.428 1 0.0 0.024 2 180.0 -0.921 3 0.0 +187 3 0.0 1 0.0 4.0 2 180.0 0.0 3 0.0 +188 3 -0.0295 1 0.0 0.95 2 180.0 -0.0225 3 0.0 +189 3 -0.077 1 0.0 0.022 2 180.0 -0.043 3 0.0 + Tinker Types 1 234 diff --git a/examples/amoeba/in.ubiquitin b/examples/amoeba/in.ubiquitin index 60c1b79054..84627a2941 100644 --- a/examples/amoeba/in.ubiquitin +++ b/examples/amoeba/in.ubiquitin @@ -7,7 +7,7 @@ atom_style amoeba bond_style class2 angle_style amoeba -dihedral_style none +dihedral_style fourier # per-atom properties required by AMOEBA or HIPPO diff --git a/tools/tinker2lmp.py b/tools/tinker2lmp.py index 4d272c3fa9..a78d0d263c 100644 --- a/tools/tinker2lmp.py +++ b/tools/tinker2lmp.py @@ -294,18 +294,28 @@ class PRMfile: class2 = int(words[2]) class3 = int(words[3]) class4 = int(words[4]) - value1 = words[5] - value2 = words[6] - value3 = words[7] - value4 = words[8] - value5 = words[9] - value6 = words[10] - value7 = words[11] - value8 = words[12] - value9 = words[13] - params.append((class1,class2,class3,class4, - value1,value2,value3,value4,value5, - value6,value7,value8,value9)) + + if len(words) <= 5: + print "Torsion has no params",class1,class2,class3,class4 + sys.exit() + if (len(words)-5) % 3: + print "Torsion does not have triplets of params", \ + class1,class2,class3,class4 + sys.exit() + + mfourier = (len(words)-5) / 3 + oneparams = [class1,class2,class3,class4,mfourier] + + for iset in range(mfourier): + value1 = float(words[5 + iset*3 + 0]) + value2 = float(words[5 + iset*3 + 1]) + value3 = int(words[5 + iset*3 + 2]) + lmp1 = value1/2.0 + lmp2 = value3 + lmp3 = value2 + oneparams += [lmp1,lmp2,lmp3] + + params.append(oneparams) iline += 1 return params @@ -493,13 +503,14 @@ for atom2 in id: # generate topology via triple loop over neighbors of dihedral atom2 # double loop over bonds of atom2 # additional loop over bonds of atom3 -# avoid double counting by requiring atom1 < atom3 +# avoid double counting the reverse dihedral by use of ddict dictionary id = xyz.id type = xyz.type bonds = xyz.bonds dlist = [] +ddict = {} for atom2 in id: for atom1 in bonds[atom2-1]: @@ -507,8 +518,9 @@ for atom2 in id: if atom3 == atom1: continue for atom4 in bonds[atom3-1]: if atom4 == atom2 or atom4 == atom1: continue - if atom1 < atom3: - dlist.append((atom1,atom2,atom3,atom4)) + if (atom4,atom3,atom2,atom1) in ddict: continue + dlist.append((atom1,atom2,atom3,atom4)) + ddict[(atom1,atom2,atom3,atom4)] = 1 # ---------------------------------------- # create lists of bond/angle/dihedral types @@ -651,13 +663,6 @@ for atom1,atom2,atom3 in alist: which = 3 m += 2 - print "4-bond angle" - print " angle atom IDs:",atom1,atom2,atom3 - print " angle atom classes:",c1,c2,c3 - print " Tinker FF file param options:",len(params[3]) - print " Nbonds and hydrogen count:",nbonds,hcount - print " which:",which,m - else: print "Angle not found",atom1,atom2,atom3,c1,c2,c3 sys.exit() @@ -724,8 +729,8 @@ for atom1,atom2,atom3,atom4 in dlist: sys.exit() if not flags[m]: - v1,v2,v3,v4,v5,v6,v7,v8,v9 = params[4:] - dparams.append((v1,v2,v3,v4,v5,v6,v7,v8,v9)) + oneparams = params[4:] + dparams.append(oneparams) flags[m] = len(dparams) dtype.append(flags[m]) @@ -869,7 +874,8 @@ if ndihedrals: lines = [] for i,one in enumerate(dparams): - line = "%d %s" % (i+1,' '.join(one)) + strone = [str(single) for single in one] + line = "%d %s" % (i+1,' '.join(strone)) lines.append(line+'\n') d.sections["Dihedral Coeffs"] = lines From 1450af8ba19991984c682ffb52fa253f5c30d06c Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Fri, 22 Oct 2021 17:01:20 -0600 Subject: [PATCH 048/585] Latest version of PairGrid --- src/ML-SNAP/pair_sna_grid.cpp | 8 ++++---- src/ML-SNAP/pair_sna_grid.h | 1 - src/pair_grid.cpp | 11 +++++++---- src/pair_grid.h | 2 +- src/verlet.cpp | 6 ++++++ 5 files changed, 18 insertions(+), 10 deletions(-) diff --git a/src/ML-SNAP/pair_sna_grid.cpp b/src/ML-SNAP/pair_sna_grid.cpp index f2176b7520..3bfdcb7e12 100644 --- a/src/ML-SNAP/pair_sna_grid.cpp +++ b/src/ML-SNAP/pair_sna_grid.cpp @@ -205,8 +205,8 @@ void PairSNAGrid::settings(int narg, char ** arg) // process required arguments - memory->create(radelem,ntypes+1,"sna/grid/local:radelem"); // offset by 1 to match up with types - memory->create(wjelem,ntypes+1,"sna/grid/local:wjelem"); + memory->create(radelem,ntypes+1,"pair:sna/grid:radelem"); // offset by 1 to match up with types + memory->create(wjelem,ntypes+1,"pair:sna/grid:wjelem"); rcutfac = atof(arg[0]); rfac0 = atof(arg[1]); @@ -221,7 +221,7 @@ void PairSNAGrid::settings(int narg, char ** arg) double cut; cutmax = 0.0; - memory->create(cutsq,ntypes+1,ntypes+1,"sna/grid/local:cutsq"); + memory->create(cutsq,ntypes+1,ntypes+1,"pair:sna/grid:cutsq"); for(int i = 1; i <= ntypes; i++) { cut = 2.0*radelem[i]*rcutfac; if (cut > cutmax) cutmax = cut; @@ -262,7 +262,7 @@ void PairSNAGrid::settings(int narg, char ** arg) if (iarg+2 > narg) error->all(FLERR,"Illegal pair sna/grid command"); chemflag = 1; - memory->create(map,ntypes+1,"compute_sna_grid_local:map"); + memory->create(map,ntypes+1,"pair:sna/grid:map"); nelements = utils::inumeric(FLERR,arg[iarg+1],false,lmp); for (int i = 0; i < ntypes; i++) { int jelem = utils::inumeric(FLERR,arg[iarg+2+i],false,lmp); diff --git a/src/ML-SNAP/pair_sna_grid.h b/src/ML-SNAP/pair_sna_grid.h index 30b6aa8f92..2216739ce3 100644 --- a/src/ML-SNAP/pair_sna_grid.h +++ b/src/ML-SNAP/pair_sna_grid.h @@ -45,7 +45,6 @@ class PairSNAGrid : public PairGrid { int *map; // map types to [0,nelements) int nelements, chemflag; class SNA *snaptr; - double cutmax; int quadraticflag; }; diff --git a/src/pair_grid.cpp b/src/pair_grid.cpp index 56478ad21f..166d4c258d 100644 --- a/src/pair_grid.cpp +++ b/src/pair_grid.cpp @@ -67,6 +67,7 @@ void PairGrid::init() void PairGrid::setup() { + printf("Hello, world! C\n"); deallocate_grid(); set_grid_global(); set_grid_local(); @@ -297,9 +298,11 @@ void PairGrid::settings(int narg, char ** arg) void PairGrid::coeff(int narg, char **arg) { if (!allocated) allocate(); - if (narg != 2 + atom->ntypes) error->all(FLERR,"Incorrect args for pair coefficients"); + if (narg != 2) error->all(FLERR,"Incorrect args for pair coefficients"); + // if (narg != 2 + atom->ntypes) error->all(FLERR,"Incorrect args for pair coefficients"); - map_element2type(narg-4,arg+4); + // map_element2type(narg-4,arg+4); + // map_element2type(0,nullptr); } @@ -321,13 +324,13 @@ void PairGrid::init_style() } /* ---------------------------------------------------------------------- - init for one type pair i,j and corresponding j,i + return maximum force cut off distance ------------------------------------------------------------------------- */ double PairGrid::init_one(int i, int j) { if (setflag[i][j] == 0) error->all(FLERR,"All pair coeffs are not set"); - return 0.0; + return cutmax; } /* ---------------------------------------------------------------------- diff --git a/src/pair_grid.h b/src/pair_grid.h index 9c40165154..d7aa151633 100644 --- a/src/pair_grid.h +++ b/src/pair_grid.h @@ -57,7 +57,7 @@ class PairGrid : public Pair { int ndesc; // number of descriptors int ndesc_base; // number of columns used for coords, etc. int gridlocal_allocated; // shows if gridlocal allocated - double **beta; // betas for all local grid points in list + double **beta; // betas for all local grid points in list int beta_max; // length of beta void allocate(); // allocate pairstyle arrays diff --git a/src/verlet.cpp b/src/verlet.cpp index b9b0b392e1..385b234a29 100644 --- a/src/verlet.cpp +++ b/src/verlet.cpp @@ -99,6 +99,8 @@ void Verlet::setup(int flag) } } + printf("Hello, world! A\n"); + if (lmp->kokkos) error->all(FLERR,"KOKKOS package requires run_style verlet/kk"); @@ -126,6 +128,8 @@ void Verlet::setup(int flag) modify->setup_post_neighbor(); neighbor->ncalls = 0; + printf("Hello, world! B\n"); + // compute all forces force->setup(); @@ -133,6 +137,8 @@ void Verlet::setup(int flag) force_clear(); modify->setup_pre_force(vflag); + printf("Hello, world!\n"); + if (pair_compute_flag) force->pair->compute(eflag,vflag); else if (force->pair) force->pair->compute_dummy(eflag,vflag); From 6d5506353b83fc369259cc29add6dc6f67d34fca Mon Sep 17 00:00:00 2001 From: LOFT Date: Sun, 24 Oct 2021 15:45:24 -0600 Subject: [PATCH 049/585] Eliminated a few mistakes,s till not working --- examples/snap/in.grid.pair | 2 +- src/ML-SNAP/pair_sna_grid.cpp | 15 +++++++------ src/ML-SNAP/pair_sna_grid.h | 7 ++++-- src/pair_grid.cpp | 40 +++++++++++++---------------------- src/pair_grid.h | 3 +-- 5 files changed, 31 insertions(+), 36 deletions(-) diff --git a/examples/snap/in.grid.pair b/examples/snap/in.grid.pair index ee40984ce6..9d21c1f62c 100644 --- a/examples/snap/in.grid.pair +++ b/examples/snap/in.grid.pair @@ -56,6 +56,6 @@ pair_style sna/grid grid ${ngrid} ${ngrid} ${ngrid} & ${rcutfac} ${rfac0} ${twojmax} ${radelem} & ${wj} rmin0 ${rmin0} bzeroflag ${bzero} & quadraticflag ${quad} switchflag ${switch} -pair_coeff * * +pair_coeff * * Al run 0 diff --git a/src/ML-SNAP/pair_sna_grid.cpp b/src/ML-SNAP/pair_sna_grid.cpp index 3bfdcb7e12..7e626edd1a 100644 --- a/src/ML-SNAP/pair_sna_grid.cpp +++ b/src/ML-SNAP/pair_sna_grid.cpp @@ -53,14 +53,11 @@ PairSNAGrid::~PairSNAGrid() /* ---------------------------------------------------------------------- */ -void PairSNAGrid::init() +void PairSNAGrid::init_style() { if (force->pair == nullptr) error->all(FLERR,"Pair sna/grid requires a pair style be defined"); - if (cutmax > force->pair->cutforce) - error->all(FLERR,"Pair sna/grid cutoff is longer than pairwise cutoff"); - // need an occasional full neighbor list int irequest = neighbor->request(this,instance_me); @@ -70,7 +67,13 @@ void PairSNAGrid::init() neighbor->requests[irequest]->full = 1; neighbor->requests[irequest]->occasional = 1; + snaptr = new SNA(lmp, rfac0, twojmax, + rmin0, switchflag, bzeroflag, + chemflag, bnormflag, wselfallflag, nelements); + ndesc = ndesc_base + snaptr->ncoeff; + printf("ndesc = %d\n", ndesc); snaptr->init(); + } /* ---------------------------------------------------------------------- */ @@ -173,8 +176,6 @@ void PairSNAGrid::compute(int eflag, int vflag) void PairSNAGrid::settings(int narg, char ** arg) { - double rfac0, rmin0; - int twojmax, switchflag, bzeroflag, bnormflag, wselfallflag; // call base class first @@ -232,6 +233,8 @@ void PairSNAGrid::settings(int narg, char ** arg) } } + printf("settings cutmax = %g \n",cutmax); + // process optional args int iarg = nargmin; diff --git a/src/ML-SNAP/pair_sna_grid.h b/src/ML-SNAP/pair_sna_grid.h index 2216739ce3..929d6db975 100644 --- a/src/ML-SNAP/pair_sna_grid.h +++ b/src/ML-SNAP/pair_sna_grid.h @@ -29,7 +29,7 @@ class PairSNAGrid : public PairGrid { PairSNAGrid(class LAMMPS *); ~PairSNAGrid(); - void init(); + void init_style(); void init_list(int, class NeighList *); void settings(int, char **); void compute(int, int); @@ -43,9 +43,12 @@ class PairSNAGrid : public PairGrid { double *radelem; double *wjelem; int *map; // map types to [0,nelements) - int nelements, chemflag; + int nelements; class SNA *snaptr; int quadraticflag; + int twojmax, switchflag, bzeroflag, bnormflag; + int chemflag, wselfallflag; + double rfac0, rmin0; }; } diff --git a/src/pair_grid.cpp b/src/pair_grid.cpp index 166d4c258d..b552b509e5 100644 --- a/src/pair_grid.cpp +++ b/src/pair_grid.cpp @@ -59,20 +59,19 @@ PairGrid::~PairGrid() /* ---------------------------------------------------------------------- */ -void PairGrid::init() -{ -} - -/* ---------------------------------------------------------------------- */ - void PairGrid::setup() { printf("Hello, world! C\n"); deallocate_grid(); + printf("Hello, world! D\n"); set_grid_global(); + printf("Hello, world! E\n"); set_grid_local(); + printf("Hello, world! F\n"); allocate_grid(); + printf("Hello, world! G\n"); assign_coords(); + printf("Hello, world! H\n"); } /* ---------------------------------------------------------------------- @@ -96,6 +95,7 @@ void PairGrid::allocate_grid() { if (nxlo <= nxhi && nylo <= nyhi && nzlo <= nzhi) { gridlocal_allocated = 1; + printf("ngridlocal = %d ndesc = %d\n",ngridlocal, ndesc); memory->create4d_offset(gridlocal,ndesc,nzlo,nzhi,nylo,nyhi, nxlo,nxhi,"pair/grid:gridlocal"); memory->create(alocal, ngridlocal, ndesc, "pair/grid:alocal"); @@ -209,6 +209,7 @@ void PairGrid::set_grid_local() void PairGrid::assign_coords() { + printf("nxhi/lo = %d %d nyhi/lo = %d %d nzhi/lo = %d %d\n",nxlo,nxhi,nylo,nyhi,nzlo,nzhi); int igrid = 0; for (int iz = nzlo; iz <= nzhi; iz++) for (int iy = nylo; iy <= nyhi; iy++) @@ -266,6 +267,10 @@ void PairGrid::allocate() allocated = 1; int n = atom->ntypes; memory->create(setflag,n+1,n+1,"pair:setflag"); + for (int i = 1; i <= n; i++) + for (int j = i; j <= n; j++) + setflag[i][j] = 0; + memory->create(cutsq,n+1,n+1,"pair:cutsq"); map = new int[n+1]; } @@ -298,38 +303,23 @@ void PairGrid::settings(int narg, char ** arg) void PairGrid::coeff(int narg, char **arg) { if (!allocated) allocate(); - if (narg != 2) error->all(FLERR,"Incorrect args for pair coefficients"); + if (narg < 2) error->all(FLERR,"Incorrect args for pair coefficients"); // if (narg != 2 + atom->ntypes) error->all(FLERR,"Incorrect args for pair coefficients"); - // map_element2type(narg-4,arg+4); + map_element2type(narg-2,arg+2); // map_element2type(0,nullptr); } -/* ---------------------------------------------------------------------- - init specific to this pair style -------------------------------------------------------------------------- */ - -void PairGrid::init_style() -{ - if (force->newton_pair == 0) - error->all(FLERR,"Pair style grid requires newton pair on"); - - // no neighbor list - - // int irequest = neighbor->request(this,instance_me); - // neighbor->requests[irequest]->half = 0; - // neighbor->requests[irequest]->full = 1; - -} - /* ---------------------------------------------------------------------- return maximum force cut off distance ------------------------------------------------------------------------- */ double PairGrid::init_one(int i, int j) { + printf("i = %d j = %d setflag = %d\n", i, j, setflag[i][j]); if (setflag[i][j] == 0) error->all(FLERR,"All pair coeffs are not set"); + printf("PairGrid cutmax = %g\n",cutmax); return cutmax; } diff --git a/src/pair_grid.h b/src/pair_grid.h index d7aa151633..97799a5c30 100644 --- a/src/pair_grid.h +++ b/src/pair_grid.h @@ -28,7 +28,7 @@ class PairGrid : public Pair { public: PairGrid(class LAMMPS *); virtual ~PairGrid(); - void init(); + virtual void init_style(){}; void setup(); virtual void compute(int, int) { printf("DANGER! This function should always be overridden by child\n"); @@ -36,7 +36,6 @@ class PairGrid : public Pair { void settings(int, char **); virtual void coeff(int, char **); - virtual void init_style(); virtual double init_one(int, int); double memory_usage(); From dcf521be53a00542c4e06b17c4114574b245a76e Mon Sep 17 00:00:00 2001 From: LOFT Date: Fri, 29 Oct 2021 06:34:32 -0600 Subject: [PATCH 050/585] Fixed a few more problems, but still no joy --- src/ML-SNAP/pair_sna_grid.cpp | 3 ++- src/ML-SNAP/pair_sna_grid.h | 3 --- src/pair_grid.cpp | 6 +++--- 3 files changed, 5 insertions(+), 7 deletions(-) diff --git a/src/ML-SNAP/pair_sna_grid.cpp b/src/ML-SNAP/pair_sna_grid.cpp index 7e626edd1a..dc3de8e941 100644 --- a/src/ML-SNAP/pair_sna_grid.cpp +++ b/src/ML-SNAP/pair_sna_grid.cpp @@ -34,9 +34,10 @@ using namespace LAMMPS_NS; PairSNAGrid::PairSNAGrid(LAMMPS *lmp) : - PairGrid(lmp), cutsq(nullptr), + PairGrid(lmp), radelem(nullptr), wjelem(nullptr) { + snaptr = nullptr; } /* ---------------------------------------------------------------------- */ diff --git a/src/ML-SNAP/pair_sna_grid.h b/src/ML-SNAP/pair_sna_grid.h index 929d6db975..9ae0eece79 100644 --- a/src/ML-SNAP/pair_sna_grid.h +++ b/src/ML-SNAP/pair_sna_grid.h @@ -37,13 +37,10 @@ class PairSNAGrid : public PairGrid { private: int ncoeff; - double **cutsq; class NeighList *list; double rcutfac; double *radelem; double *wjelem; - int *map; // map types to [0,nelements) - int nelements; class SNA *snaptr; int quadraticflag; int twojmax, switchflag, bzeroflag, bnormflag; diff --git a/src/pair_grid.cpp b/src/pair_grid.cpp index b552b509e5..dd35f75f8c 100644 --- a/src/pair_grid.cpp +++ b/src/pair_grid.cpp @@ -36,7 +36,6 @@ PairGrid::PairGrid(LAMMPS *lmp) : manybody_flag = 1; centroidstressflag = CENTROID_NOTAVAIL; - ndesc = 0; ngridlocal = 0; @@ -62,7 +61,7 @@ PairGrid::~PairGrid() void PairGrid::setup() { printf("Hello, world! C\n"); - deallocate_grid(); + // deallocate_grid(); printf("Hello, world! D\n"); set_grid_global(); printf("Hello, world! E\n"); @@ -70,7 +69,7 @@ void PairGrid::setup() printf("Hello, world! F\n"); allocate_grid(); printf("Hello, world! G\n"); - assign_coords(); + // assign_coords(); printf("Hello, world! H\n"); } @@ -273,6 +272,7 @@ void PairGrid::allocate() memory->create(cutsq,n+1,n+1,"pair:cutsq"); map = new int[n+1]; + printf("Allocated!\n"); } /* ---------------------------------------------------------------------- From 591af3f5602c8e63707f446d8727cf9931755ef8 Mon Sep 17 00:00:00 2001 From: LOFT Date: Fri, 29 Oct 2021 07:49:15 -0600 Subject: [PATCH 051/585] Eliminated obvious but hard to find error in neighbor list request --- examples/snap/in.grid.pair | 2 ++ src/ML-SNAP/pair_sna_grid.cpp | 9 +++------ src/pair_grid.cpp | 2 ++ 3 files changed, 7 insertions(+), 6 deletions(-) diff --git a/examples/snap/in.grid.pair b/examples/snap/in.grid.pair index 9d21c1f62c..5f70f79d09 100644 --- a/examples/snap/in.grid.pair +++ b/examples/snap/in.grid.pair @@ -58,4 +58,6 @@ pair_style sna/grid grid ${ngrid} ${ngrid} ${ngrid} & quadraticflag ${quad} switchflag ${switch} pair_coeff * * Al +neighbor 0.0 nsq + run 0 diff --git a/src/ML-SNAP/pair_sna_grid.cpp b/src/ML-SNAP/pair_sna_grid.cpp index dc3de8e941..6dc7bc9173 100644 --- a/src/ML-SNAP/pair_sna_grid.cpp +++ b/src/ML-SNAP/pair_sna_grid.cpp @@ -56,17 +56,14 @@ PairSNAGrid::~PairSNAGrid() void PairSNAGrid::init_style() { - if (force->pair == nullptr) - error->all(FLERR,"Pair sna/grid requires a pair style be defined"); + if (force->newton_pair == 0) + error->all(FLERR,"Pair style sna/grid requires newton pair on"); - // need an occasional full neighbor list + // need a full neighbor list int irequest = neighbor->request(this,instance_me); - neighbor->requests[irequest]->pair = 0; - neighbor->requests[irequest]->compute = 1; neighbor->requests[irequest]->half = 0; neighbor->requests[irequest]->full = 1; - neighbor->requests[irequest]->occasional = 1; snaptr = new SNA(lmp, rfac0, twojmax, rmin0, switchflag, bzeroflag, diff --git a/src/pair_grid.cpp b/src/pair_grid.cpp index dd35f75f8c..f76629717b 100644 --- a/src/pair_grid.cpp +++ b/src/pair_grid.cpp @@ -60,6 +60,7 @@ PairGrid::~PairGrid() void PairGrid::setup() { + printf("Inside PairGrid::setup()\n"); printf("Hello, world! C\n"); // deallocate_grid(); printf("Hello, world! D\n"); @@ -317,6 +318,7 @@ void PairGrid::coeff(int narg, char **arg) double PairGrid::init_one(int i, int j) { + printf("Inside PairGrid::init_one()\n"); printf("i = %d j = %d setflag = %d\n", i, j, setflag[i][j]); if (setflag[i][j] == 0) error->all(FLERR,"All pair coeffs are not set"); printf("PairGrid cutmax = %g\n",cutmax); From 161fdec54057e5000bd8bfdf8493caa9045f673f Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Fri, 10 Dec 2021 12:52:11 -0700 Subject: [PATCH 052/585] add improper amoeba class --- src/AMOEBA/improper_amoeba.cpp | 249 +++++++++++++++++++++++++++++++++ src/AMOEBA/improper_amoeba.h | 59 ++++++++ tools/tinker2lmp.py | 121 +++++++++++++++- 3 files changed, 427 insertions(+), 2 deletions(-) create mode 100644 src/AMOEBA/improper_amoeba.cpp create mode 100644 src/AMOEBA/improper_amoeba.h diff --git a/src/AMOEBA/improper_amoeba.cpp b/src/AMOEBA/improper_amoeba.cpp new file mode 100644 index 0000000000..d32b23ae2a --- /dev/null +++ b/src/AMOEBA/improper_amoeba.cpp @@ -0,0 +1,249 @@ +// clang-format off +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + https://www.lammps.org/, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#include "improper_amoeba.h" + +#include +#include "atom.h" +#include "comm.h" +#include "neighbor.h" +#include "force.h" +#include "update.h" +#include "math_const.h" +#include "memory.h" +#include "error.h" + +using namespace LAMMPS_NS; +using namespace MathConst; + +#define TOLERANCE 0.05 +#define SMALL 0.001 + +/* ---------------------------------------------------------------------- */ + +ImproperAmoeba::ImproperAmoeba(LAMMPS *lmp) : Improper(lmp) +{ + writedata = 1; +} + +/* ---------------------------------------------------------------------- */ + +ImproperAmoeba::~ImproperAmoeba() +{ + if (allocated && !copymode) { + memory->destroy(setflag); + memory->destroy(k); + } +} + +/* ---------------------------------------------------------------------- */ + +void ImproperAmoeba::compute(int eflag, int vflag) +{ + int ia,ib,ic,id,n,type; + double xia,yia,zia,xib,yib,zib,xic,yic,zic,xid,yid,zid; + double xab,yab,zab,xcb,ycb,zcb,xdb,ydb,zdb,xad,yad,zad,xcd,ycd,zcd; + double rad2,rcd2,rdb2,dot,cc,ee; + double sine,angle; + double eimproper,f1[3],f2[3],f3[3],f4[3]; + + eimproper = 0.0; + ev_init(eflag,vflag); + + double **x = atom->x; + double **f = atom->f; + int **improperlist = neighbor->improperlist; + int nimproperlist = neighbor->nimproperlist; + int nlocal = atom->nlocal; + int newton_bond = force->newton_bond; + + for (n = 0; n < nimproperlist; n++) { + + // in Tinker code, atom1 = D, atom2 = B, atom3 = A, atom4 = C + // for Alligner angle: + // atoms A,C,D form a plane, B is out-of-plane + // angle is between plane and the vector from D to B + + id = improperlist[n][0]; + ib = improperlist[n][1]; + ia = improperlist[n][2]; + ic = improperlist[n][3]; + type = improperlist[n][4]; + + // coordinates of the atoms at trigonal center + + xia = x[ia][0]; + yia = x[ia][1]; + zia = x[ia][2]; + xib = x[ib][0]; + yib = x[ib][1]; + zib = x[ib][2]; + xic = x[ic][0]; + yic = x[ic][1]; + zic = x[ic][2]; + xid = x[id][0]; + yid = x[id][1]; + zid = x[id][2]; + + // compute the out-of-plane bending angle + + xab = xia - xib; + yab = yia - yib; + zab = zia - zib; + xcb = xic - xib; + ycb = yic - yib; + zcb = zic - zib; + xdb = xid - xib; + ydb = yid - yib; + zdb = zid - zib; + xad = xia - xid; + yad = yia - yid; + zad = zia - zid; + xcd = xic - xid; + ycd = yic - yid; + zcd = zic - zid; + + // Allinger angle between A-C-D plane and D-B vector for D-B < AC + + rad2 = xad*xad + yad*yad + zad*zad; + rcd2 = xcd*xcd + ycd*ycd + zcd*zcd; + dot = xad*xcd + yad*ycd + zad*zcd; + cc = rad2*rcd2 - dot*dot; + + // find the out-of-plane angle bending energy + + ee = xdb*(yab*zcb-zab*ycb) + ydb*(zab*xcb-xab*zcb) + zdb*(xab*ycb-yab*xcb); + rdb2 = xdb*xdb + ydb*ydb + zdb*zdb; + if (rdb2 == 0.0 || cc == 0.0) continue; + + sine = fabs(ee) / sqrt(cc*rdb2); + sine = MIN(1.0,sine); + angle = asin(sine) * MY_PI/180.0; + + //dt = angle; + //dt2 = dt * dt; + //dt3 = dt2 * dt; + //dt4 = dt2 * dt2; + //e = opbunit * force * dt2 * (1.0d0+copb*dt+qopb*dt2+popb*dt3+sopb*dt4); + //deddt = opbunit * force * dt * radian * + // (2.0d0 + 3.0d0*copb*dt + 4.0d0*qopb*dt2 + 5.0d0*popb*dt3 + 6.0d0*sopb*dt4); + //dedcos = -deddt * sign(1.0d0,ee) / sqrt(cc*rdb2-ee*ee); + + /* + // apply force to each of 4 atoms + + if (newton_bond || i1 < nlocal) { + f[i1][0] += f1[0]; + f[i1][1] += f1[1]; + f[i1][2] += f1[2]; + } + + if (newton_bond || i2 < nlocal) { + f[i2][0] += f2[0]; + f[i2][1] += f2[1]; + f[i2][2] += f2[2]; + } + + if (newton_bond || i3 < nlocal) { + f[i3][0] += f3[0]; + f[i3][1] += f3[1]; + f[i3][2] += f3[2]; + } + + if (newton_bond || i4 < nlocal) { + f[i4][0] += f4[0]; + f[i4][1] += f4[1]; + f[i4][2] += f4[2]; + } + + if (evflag) + ev_tally(i1,i2,i3,i4,nlocal,newton_bond,eimproper,f1,f3,f4, + vb1x,vb1y,vb1z,vb2x,vb2y,vb2z,vb3x,vb3y,vb3z); + */ + } +} + +/* ---------------------------------------------------------------------- */ + +void ImproperAmoeba::allocate() +{ + allocated = 1; + int n = atom->nimpropertypes; + + memory->create(k,n+1,"improper:k"); + + memory->create(setflag,n+1,"improper:setflag"); + for (int i = 1; i <= n; i++) setflag[i] = 0; +} + +/* ---------------------------------------------------------------------- + set coeffs for one type +------------------------------------------------------------------------- */ + +void ImproperAmoeba::coeff(int narg, char **arg) +{ + if (narg != 2) error->all(FLERR,"Incorrect args for improper coefficients"); + if (!allocated) allocate(); + + int ilo,ihi; + utils::bounds(FLERR,arg[0],1,atom->nimpropertypes,ilo,ihi,error); + + double k_one = utils::numeric(FLERR,arg[1],false,lmp); + + // convert chi from degrees to radians + + int count = 0; + for (int i = ilo; i <= ihi; i++) { + k[i] = k_one; + setflag[i] = 1; + count++; + } + + if (count == 0) error->all(FLERR,"Incorrect args for improper coefficients"); +} + +/* ---------------------------------------------------------------------- + proc 0 writes out coeffs to restart file +------------------------------------------------------------------------- */ + +void ImproperAmoeba::write_restart(FILE *fp) +{ + fwrite(&k[1],sizeof(double),atom->nimpropertypes,fp); +} + +/* ---------------------------------------------------------------------- + proc 0 reads coeffs from restart file, bcasts them +------------------------------------------------------------------------- */ + +void ImproperAmoeba::read_restart(FILE *fp) +{ + allocate(); + + if (comm->me == 0) { + utils::sfread(FLERR,&k[1],sizeof(double),atom->nimpropertypes,fp,nullptr,error); + } + MPI_Bcast(&k[1],atom->nimpropertypes,MPI_DOUBLE,0,world); + + for (int i = 1; i <= atom->nimpropertypes; i++) setflag[i] = 1; +} + +/* ---------------------------------------------------------------------- + proc 0 writes to data file +------------------------------------------------------------------------- */ + +void ImproperAmoeba::write_data(FILE *fp) +{ + for (int i = 1; i <= atom->nimpropertypes; i++) + fprintf(fp,"%d %g\n",i,k[i]); +} diff --git a/src/AMOEBA/improper_amoeba.h b/src/AMOEBA/improper_amoeba.h new file mode 100644 index 0000000000..439a6c39fb --- /dev/null +++ b/src/AMOEBA/improper_amoeba.h @@ -0,0 +1,59 @@ +/* -*- c++ -*- ---------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + https://www.lammps.org/, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#ifdef IMPROPER_CLASS +// clang-format off +ImproperStyle(amoeba,ImproperAmoeba); +// clang-format on +#else + +#ifndef LMP_IMPROPER_AMOEBA_H +#define LMP_IMPROPER_AMOEBA_H + +#include "improper.h" + +namespace LAMMPS_NS { + +class ImproperAmoeba : public Improper { + public: + ImproperAmoeba(class LAMMPS *); + ~ImproperAmoeba(); + void compute(int, int); + void coeff(int, char **); + void write_restart(FILE *); + void read_restart(FILE *); + void write_data(FILE *); + + protected: + double *k; + + virtual void allocate(); +}; + +} // namespace LAMMPS_NS + +#endif +#endif + +/* ERROR/WARNING messages: + +W: Improper problem: %d %ld %d %d %d %d + +Conformation of the 4 listed improper atoms is extreme; you may want +to check your simulation geometry. + +E: Incorrect args for improper coefficients + +Self-explanatory. Check the input script or data file. + +*/ diff --git a/tools/tinker2lmp.py b/tools/tinker2lmp.py index a78d0d263c..63a5b6d154 100644 --- a/tools/tinker2lmp.py +++ b/tools/tinker2lmp.py @@ -10,6 +10,8 @@ # -nopbc = non-periodic system (default) # -pbc xhi yhi zhi = periodic system from 0 to hi in each dimension (optional) +# Author: Steve Plimpton + import sys,os,math path = os.environ["LAMMPS_PYTHON_TOOLS"] sys.path.append(path) @@ -105,6 +107,7 @@ class PRMfile: self.angleparams = self.angles() self.bondangleparams = self.bondangles() self.torsionparams = self.torsions() + self.opbendparams = self.opbend() self.ntypes = len(self.masses) def force_field_definition(self): @@ -280,6 +283,8 @@ class PRMfile: iline += 1 return params + # Dihedral interactions + def torsions(self): params = [] iline = self.find_section("Torsional Parameters") @@ -318,6 +323,28 @@ class PRMfile: params.append(oneparams) iline += 1 return params + + # Improper or out-of-plane bend interactions + + def opbend(self): + params = [] + iline = self.find_section("Out-of-Plane Bend Parameters") + if iline < 0: return params + iline += 3 + while iline < self.nlines: + words = self.lines[iline].split() + if len(words): + if words[0].startswith("###########"): break + if words[0] == "opbend": + class1 = int(words[1]) + class2 = int(words[2]) + class3 = int(words[3]) + class4 = int(words[4]) + value1 = float(words[5]) + lmp1 = value1 + params.append((class1,class2,class3,class4,lmp1)) + iline += 1 + return params def find_section(self,txt): txt = "## %s ##" % txt @@ -522,8 +549,30 @@ for atom2 in id: dlist.append((atom1,atom2,atom3,atom4)) ddict[(atom1,atom2,atom3,atom4)] = 1 +# create olist = list of out-of-plane impropers +# generate topology by triple loop over bonds of center atom2 +# atom2 must have 3 or more bonds to be part of an improper +# avoid double counting by requiring atom3 < atom4 +# this is since in Tinker the final 2 atoms in the improper are interchangeable + +id = xyz.id +type = xyz.type +bonds = xyz.bonds + +olist = [] + +for atom2 in id: + if len(bonds[atom2-1]) < 3: continue + for atom1 in bonds[atom2-1]: + for atom3 in bonds[atom2-1]: + for atom4 in bonds[atom2-1]: + if atom1 == atom3: continue + if atom1 == atom4: continue + if atom3 >= atom4: continue + olist.append((atom1,atom2,atom3,atom4)) + # ---------------------------------------- -# create lists of bond/angle/dihedral types +# create lists of bond/angle/dihedral/improper types # ---------------------------------------- # generate btype = LAMMPS type of each bond @@ -697,7 +746,7 @@ for atom1,atom2,atom3 in alist: # flags[i] = which LAMMPS dihedral type (1-N) the Tinker FF file dihedral I is # 0 = none # convert prm.torsionparams to a dictionary for efficient searching -# key = (class1,class2) +# key = (class1,class2,class3,class4) # value = (M,params) where M is index into prm.torsionparams id = xyz.id @@ -734,6 +783,54 @@ for atom1,atom2,atom3,atom4 in dlist: flags[m] = len(dparams) dtype.append(flags[m]) +# generate otype = LAMMPS type of each out-of-plane improper +# generate oparams = LAMMPS params for each improper type +# flags[i] = which LAMMPS improper type (1-N) the Tinker FF file improper I is +# 0 = none +# convert prm.opbendparams to a dictionary for efficient searching +# key = (class1,class2) +# value = (M,params) where M is index into prm.opbendparams + +id = xyz.id +type = xyz.type +classes = prm.classes + +odict = {} +for m,params in enumerate(prm.opbendparams): + odict[(params[0],params[1])] = (m,params) + +flags = len(prm.opbendparams)*[0] +otype = [] +oparams = [] +olist_reduced = [] + +for atom1,atom2,atom3,atom4 in olist: + type1 = type[atom1-1] + type2 = type[atom2-1] + type3 = type[atom3-1] + type4 = type[atom4-1] + c1 = classes[type1-1] + c2 = classes[type2-1] + c3 = classes[type3-1] + c4 = classes[type4-1] + + # 4-tuple is only an improper if matches an entry in PRM file + # olist_reduced = list of just these 4-tuples + + if (c1,c2) in odict: + m,params = odict[(c1,c2)] + olist_reduced.append((atom1,atom2,atom3,atom4)) + + if not flags[m]: + oneparams = params[4:] + oparams.append(oneparams) + flags[m] = len(oparams) + otype.append(flags[m]) + +# replace original olist with reduced version + +olist = olist_reduced + # ---------------------------------------- # assign each atom to a Tinker group # NOTE: doing this inside LAMMPS now @@ -787,6 +884,7 @@ ttype = xyz.type nbonds = len(blist) nangles = len(alist) ndihedrals = len(dlist) +nimpropers = len(olist) # data file header values @@ -885,6 +983,23 @@ if ndihedrals: lines.append(line+'\n') d.sections["Dihedrals"] = lines +if nimpropers: + d.headers["impropers"] = len(olist) + d.headers["improper types"] = len(oparams) + + lines = [] + for i,one in enumerate(oparams): + strone = [str(single) for single in one] + line = "%d %s" % (i+1,' '.join(strone)) + lines.append(line+'\n') + d.sections["Improper Coeffs"] = lines + + lines = [] + for i,one in enumerate(olist): + line = "%d %d %d %d %d %d" % (i+1,otype[i],one[0],one[1],one[2],one[3]) + lines.append(line+'\n') + d.sections["Impropers"] = lines + d.write(datafile) # print stats to screen @@ -898,6 +1013,8 @@ print "Nmol =",nmol print "Nbonds =",len(blist) print "Nangles =",len(alist) print "Ndihedrals =",len(dlist) +print "Nimpropers =",len(olist) print "Nbondtypes =",len(bparams) print "Nangletypes =",len(aparams) print "Ndihedraltypes =",len(dparams) +print "Nimpropertypes =",len(oparams) From c69edde55cf3245c9ab30bf455927be94f63b232 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Fri, 10 Dec 2021 18:30:44 -0700 Subject: [PATCH 053/585] Eliminated several undefined variables --- examples/snap/in.grid.pair | 8 +++----- src/ML-SNAP/pair_sna_grid.cpp | 10 +++++----- src/pair_grid.cpp | 17 ++--------------- src/verlet.cpp | 6 ------ 4 files changed, 10 insertions(+), 31 deletions(-) diff --git a/examples/snap/in.grid.pair b/examples/snap/in.grid.pair index 5f70f79d09..e2143427e6 100644 --- a/examples/snap/in.grid.pair +++ b/examples/snap/in.grid.pair @@ -1,8 +1,5 @@ -# Demonstrate bispectrum computes +# Demonstrate pair style base on sna/grid -# CORRECTNESS: thermo output for c_mygrid[*][1] and c_mygrid[*][8] should -# match the values in dump_b: 108.173 3.21778 0.712238 7.06634 1.04273 - # Initialize simulation variable nsteps index 0 @@ -58,6 +55,7 @@ pair_style sna/grid grid ${ngrid} ${ngrid} ${ngrid} & quadraticflag ${quad} switchflag ${switch} pair_coeff * * Al +thermo_style custom step temp epair emol etotal press neighbor 0.0 nsq -run 0 +run 10 diff --git a/src/ML-SNAP/pair_sna_grid.cpp b/src/ML-SNAP/pair_sna_grid.cpp index 6dc7bc9173..5be3bf98d6 100644 --- a/src/ML-SNAP/pair_sna_grid.cpp +++ b/src/ML-SNAP/pair_sna_grid.cpp @@ -68,8 +68,8 @@ void PairSNAGrid::init_style() snaptr = new SNA(lmp, rfac0, twojmax, rmin0, switchflag, bzeroflag, chemflag, bnormflag, wselfallflag, nelements); - ndesc = ndesc_base + snaptr->ncoeff; - printf("ndesc = %d\n", ndesc); + ncoeff = snaptr->ncoeff; + ndesc = ndesc_base + ncoeff; snaptr->init(); } @@ -85,6 +85,7 @@ void PairSNAGrid::init_list(int /*id*/, NeighList *ptr) void PairSNAGrid::compute(int eflag, int vflag) { + ev_init(eflag,vflag); // compute sna for each gridpoint @@ -165,6 +166,8 @@ void PairSNAGrid::compute(int eflag, int vflag) } } } + + if (vflag_fdotr) virial_fdotr_compute(); } @@ -231,14 +234,11 @@ void PairSNAGrid::settings(int narg, char ** arg) } } - printf("settings cutmax = %g \n",cutmax); - // process optional args int iarg = nargmin; while (iarg < narg) { - printf("%d %d %d %s\n",iarg,narg,nargbase,arg[iarg]); if (strcmp(arg[iarg],"rmin0") == 0) { if (iarg+2 > narg) error->all(FLERR,"Illegal pair sna/grid command"); diff --git a/src/pair_grid.cpp b/src/pair_grid.cpp index f76629717b..3f88635ecf 100644 --- a/src/pair_grid.cpp +++ b/src/pair_grid.cpp @@ -60,18 +60,11 @@ PairGrid::~PairGrid() void PairGrid::setup() { - printf("Inside PairGrid::setup()\n"); - printf("Hello, world! C\n"); - // deallocate_grid(); - printf("Hello, world! D\n"); + deallocate_grid(); set_grid_global(); - printf("Hello, world! E\n"); set_grid_local(); - printf("Hello, world! F\n"); allocate_grid(); - printf("Hello, world! G\n"); - // assign_coords(); - printf("Hello, world! H\n"); + assign_coords(); } /* ---------------------------------------------------------------------- @@ -95,7 +88,6 @@ void PairGrid::allocate_grid() { if (nxlo <= nxhi && nylo <= nyhi && nzlo <= nzhi) { gridlocal_allocated = 1; - printf("ngridlocal = %d ndesc = %d\n",ngridlocal, ndesc); memory->create4d_offset(gridlocal,ndesc,nzlo,nzhi,nylo,nyhi, nxlo,nxhi,"pair/grid:gridlocal"); memory->create(alocal, ngridlocal, ndesc, "pair/grid:alocal"); @@ -209,7 +201,6 @@ void PairGrid::set_grid_local() void PairGrid::assign_coords() { - printf("nxhi/lo = %d %d nyhi/lo = %d %d nzhi/lo = %d %d\n",nxlo,nxhi,nylo,nyhi,nzlo,nzhi); int igrid = 0; for (int iz = nzlo; iz <= nzhi; iz++) for (int iy = nylo; iy <= nyhi; iy++) @@ -273,7 +264,6 @@ void PairGrid::allocate() memory->create(cutsq,n+1,n+1,"pair:cutsq"); map = new int[n+1]; - printf("Allocated!\n"); } /* ---------------------------------------------------------------------- @@ -318,10 +308,7 @@ void PairGrid::coeff(int narg, char **arg) double PairGrid::init_one(int i, int j) { - printf("Inside PairGrid::init_one()\n"); - printf("i = %d j = %d setflag = %d\n", i, j, setflag[i][j]); if (setflag[i][j] == 0) error->all(FLERR,"All pair coeffs are not set"); - printf("PairGrid cutmax = %g\n",cutmax); return cutmax; } diff --git a/src/verlet.cpp b/src/verlet.cpp index 385b234a29..b9b0b392e1 100644 --- a/src/verlet.cpp +++ b/src/verlet.cpp @@ -99,8 +99,6 @@ void Verlet::setup(int flag) } } - printf("Hello, world! A\n"); - if (lmp->kokkos) error->all(FLERR,"KOKKOS package requires run_style verlet/kk"); @@ -128,8 +126,6 @@ void Verlet::setup(int flag) modify->setup_post_neighbor(); neighbor->ncalls = 0; - printf("Hello, world! B\n"); - // compute all forces force->setup(); @@ -137,8 +133,6 @@ void Verlet::setup(int flag) force_clear(); modify->setup_pre_force(vflag); - printf("Hello, world!\n"); - if (pair_compute_flag) force->pair->compute(eflag,vflag); else if (force->pair) force->pair->compute_dummy(eflag,vflag); From 67f7e44688300b8fe3c22e4af9ef83409eb9b9f1 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Wed, 15 Dec 2021 11:44:38 -0700 Subject: [PATCH 054/585] changes to angle and improper amoeba terms --- src/AMOEBA/angle_amoeba.cpp | 146 ++++++++++++++++++++++++++++----- src/AMOEBA/angle_amoeba.h | 2 + src/AMOEBA/improper_amoeba.cpp | 133 +++++++++++++++++++++++------- src/AMOEBA/improper_amoeba.h | 2 + src/AMOEBA/pair_amoeba.cpp | 12 +++ src/AMOEBA/pair_amoeba.h | 2 + 6 files changed, 246 insertions(+), 51 deletions(-) diff --git a/src/AMOEBA/angle_amoeba.cpp b/src/AMOEBA/angle_amoeba.cpp index 6faf2edbdd..57079cdd83 100644 --- a/src/AMOEBA/angle_amoeba.cpp +++ b/src/AMOEBA/angle_amoeba.cpp @@ -41,6 +41,11 @@ AngleAmoeba::AngleAmoeba(LAMMPS *lmp) : Angle(lmp) k4 = nullptr; k5 = nullptr; k6 = nullptr; + + ba_k1 = nullptr; + ba_k2 = nullptr; + ba_r1 = nullptr; + ba_r2 = nullptr; } /* ---------------------------------------------------------------------- */ @@ -51,6 +56,8 @@ AngleAmoeba::~AngleAmoeba() if (allocated) { memory->destroy(setflag); + memory->destroy(setflag_a); + memory->destroy(setflag_ba); memory->destroy(pflag); memory->destroy(theta0); @@ -59,6 +66,11 @@ AngleAmoeba::~AngleAmoeba() memory->destroy(k4); memory->destroy(k5); memory->destroy(k6); + + memory->destroy(ba_k1); + memory->destroy(ba_k2); + memory->destroy(ba_r1); + memory->destroy(ba_r2); } } @@ -72,6 +84,7 @@ void AngleAmoeba::compute(int eflag, int vflag) double dtheta,dtheta2,dtheta3,dtheta4,dtheta5,dtheta6,de_angle; double dr1,dr2,tk1,tk2,aa1,aa2,aa11,aa12,aa21,aa22; double rsq1,rsq2,r1,r2,c,s,a,a11,a12,a22,b1,b2; + double vx11,vx12,vy11,vy12,vz11,vz12,vx21,vx22,vy21,vy22,vz21,vz22; eangle = 0.0; ev_init(eflag,vflag); @@ -159,6 +172,50 @@ void AngleAmoeba::compute(int eflag, int vflag) if (eflag) eangle = k2[type]*dtheta2 + k3[type]*dtheta3 + k4[type]*dtheta4 + k5[type]*dtheta5 + k6[type]*dtheta6; + // force & energy for bond-angle term + // bond-stretch cross term in Tinker + + dr1 = r1 - ba_r1[type]; + dr2 = r2 - ba_r2[type]; + + aa1 = s * dr1 * ba_k1[type]; + aa2 = s * dr2 * ba_k2[type]; + + aa11 = aa1 * c / rsq1; + aa12 = -aa1 / (r1 * r2); + aa21 = aa2 * c / rsq1; + aa22 = -aa2 / (r1 * r2); + + vx11 = (aa11 * delx1) + (aa12 * delx2); + vx12 = (aa21 * delx1) + (aa22 * delx2); + vy11 = (aa11 * dely1) + (aa12 * dely2); + vy12 = (aa21 * dely1) + (aa22 * dely2); + vz11 = (aa11 * delz1) + (aa12 * delz2); + vz12 = (aa21 * delz1) + (aa22 * delz2); + + aa11 = aa1 * c / rsq2; + aa21 = aa2 * c / rsq2; + + vx21 = (aa11 * delx2) + (aa12 * delx1); + vx22 = (aa21 * delx2) + (aa22 * delx1); + vy21 = (aa11 * dely2) + (aa12 * dely1); + vy22 = (aa21 * dely2) + (aa22 * dely1); + vz21 = (aa11 * delz2) + (aa12 * delz1); + vz22 = (aa21 * delz2) + (aa22 * delz1); + + b1 = ba_k1[type] * dtheta / r1; + b2 = ba_k2[type] * dtheta / r2; + + f1[0] -= vx11 + b1*delx1 + vx12; + f1[1] -= vy11 + b1*dely1 + vy12; + f1[2] -= vz11 + b1*delz1 + vz12; + + f3[0] -= vx21 + b2*delx2 + vx22; + f3[1] -= vy21 + b2*dely2 + vy22; + f3[2] -= vz21 + b2*delz2 + vz22; + + if (eflag) eangle += ba_k1[type]*dr1*dtheta + ba_k2[type]*dr2*dtheta; + // apply force to each of 3 atoms if (newton_bond || i1 < nlocal) { @@ -382,8 +439,13 @@ void AngleAmoeba::allocate() memory->create(k5,n+1,"angle:k5"); memory->create(k6,n+1,"angle:k6"); + memory->create(ba_k1,n+1,"angle:ba_k1"); + memory->create(ba_k2,n+1,"angle:ba_k2"); + memory->create(ba_r1,n+1,"angle:ba_r1"); + memory->create(ba_r2,n+1,"angle:ba_r2"); + memory->create(setflag,n+1,"angle:setflag"); - for (int i = 1; i <= n; i++) setflag[i] = 0; + for (int i = 1; i <= n; i++) setflag[i] = setflag_a[i] = setflag_ba[i] = 0; } /* ---------------------------------------------------------------------- @@ -392,6 +454,7 @@ void AngleAmoeba::allocate() void AngleAmoeba::coeff(int narg, char **arg) { + if (narg < 2) error->all(FLERR,"Incorrect args for angle coefficients"); if (!allocated) allocate(); int ilo,ihi; @@ -399,32 +462,52 @@ void AngleAmoeba::coeff(int narg, char **arg) int count = 0; - if (narg != 8) error->all(FLERR,"Incorrect args for angle coefficients"); + if (strcmp(arg[1],"ba") == 0) { + if (narg != 6) error->all(FLERR,"Incorrect args for angle coefficients"); - int pflag_one = utils::inumeric(FLERR,arg[1],false,lmp); - double theta0_one = utils::numeric(FLERR,arg[2],false,lmp); - double k2_one = utils::numeric(FLERR,arg[3],false,lmp); - double k3_one = utils::numeric(FLERR,arg[4],false,lmp); - double k4_one = utils::numeric(FLERR,arg[5],false,lmp); - double k5_one = utils::numeric(FLERR,arg[6],false,lmp); - double k6_one = utils::numeric(FLERR,arg[7],false,lmp); + double ba_k1_one = utils::numeric(FLERR,arg[2],false,lmp); + double ba_k2_one = utils::numeric(FLERR,arg[3],false,lmp); + double ba_r1_one = utils::numeric(FLERR,arg[4],false,lmp); + double ba_r2_one = utils::numeric(FLERR,arg[5],false,lmp); - // convert theta0 from degrees to radians + for (int i = ilo; i <= ihi; i++) { + ba_k1[i] = ba_k1_one; + ba_k2[i] = ba_k2_one; + ba_r1[i] = ba_r1_one; + ba_r2[i] = ba_r2_one; + setflag_ba[i] = 1; + count++; + } + + } else { + if (narg != 8) error->all(FLERR,"Incorrect args for angle coefficients"); + + int pflag_one = utils::inumeric(FLERR,arg[1],false,lmp); + double theta0_one = utils::numeric(FLERR,arg[2],false,lmp); + double k2_one = utils::numeric(FLERR,arg[3],false,lmp); + double k3_one = utils::numeric(FLERR,arg[4],false,lmp); + double k4_one = utils::numeric(FLERR,arg[5],false,lmp); + double k5_one = utils::numeric(FLERR,arg[6],false,lmp); + double k6_one = utils::numeric(FLERR,arg[7],false,lmp); + + // convert theta0 from degrees to radians - for (int i = ilo; i <= ihi; i++) { - pflag[i] = pflag_one; - theta0[i] = theta0_one/180.0 * MY_PI; - k2[i] = k2_one; - k3[i] = k3_one; - k4[i] = k4_one; - k5[i] = k5_one; - k6[i] = k6_one; - count++; + for (int i = ilo; i <= ihi; i++) { + pflag[i] = pflag_one; + theta0[i] = theta0_one/180.0 * MY_PI; + k2[i] = k2_one; + k3[i] = k3_one; + k4[i] = k4_one; + k5[i] = k5_one; + k6[i] = k6_one; + count++; + } } if (count == 0) error->all(FLERR,"Incorrect args for angle coefficients"); - for (int i = ilo; i <= ihi; i++) setflag[i] = 1; + for (int i = ilo; i <= ihi; i++) + if (setflag_a[i] == 1 && setflag_ba[i] == 1) setflag[i] = 1; } /* ---------------------------------------------------------------------- */ @@ -447,6 +530,11 @@ void AngleAmoeba::write_restart(FILE *fp) fwrite(&k4[1],sizeof(double),atom->nangletypes,fp); fwrite(&k5[1],sizeof(double),atom->nangletypes,fp); fwrite(&k6[1],sizeof(double),atom->nangletypes,fp); + + fwrite(&ba_k1[1],sizeof(double),atom->nangletypes,fp); + fwrite(&ba_k2[1],sizeof(double),atom->nangletypes,fp); + fwrite(&ba_r1[1],sizeof(double),atom->nangletypes,fp); + fwrite(&ba_r2[1],sizeof(double),atom->nangletypes,fp); } /* ---------------------------------------------------------------------- @@ -465,6 +553,11 @@ void AngleAmoeba::read_restart(FILE *fp) utils::sfread(FLERR,&k4[1],sizeof(double),atom->nangletypes,fp,nullptr,error); utils::sfread(FLERR,&k5[1],sizeof(double),atom->nangletypes,fp,nullptr,error); utils::sfread(FLERR,&k6[1],sizeof(double),atom->nangletypes,fp,nullptr,error); + + utils::sfread(FLERR,&ba_k1[1],sizeof(double),atom->nangletypes,fp,nullptr,error); + utils::sfread(FLERR,&ba_k2[1],sizeof(double),atom->nangletypes,fp,nullptr,error); + utils::sfread(FLERR,&ba_r1[1],sizeof(double),atom->nangletypes,fp,nullptr,error); + utils::sfread(FLERR,&ba_r2[1],sizeof(double),atom->nangletypes,fp,nullptr,error); } MPI_Bcast(&pflag[1],atom->nangletypes,MPI_INT,0,world); @@ -475,6 +568,11 @@ void AngleAmoeba::read_restart(FILE *fp) MPI_Bcast(&k5[1],atom->nangletypes,MPI_DOUBLE,0,world); MPI_Bcast(&k6[1],atom->nangletypes,MPI_DOUBLE,0,world); + MPI_Bcast(&ba_k1[1],atom->nangletypes,MPI_DOUBLE,0,world); + MPI_Bcast(&ba_k2[1],atom->nangletypes,MPI_DOUBLE,0,world); + MPI_Bcast(&ba_r1[1],atom->nangletypes,MPI_DOUBLE,0,world); + MPI_Bcast(&ba_r2[1],atom->nangletypes,MPI_DOUBLE,0,world); + for (int i = 1; i <= atom->nangletypes; i++) setflag[i] = 1; } @@ -487,6 +585,10 @@ void AngleAmoeba::write_data(FILE *fp) for (int i = 1; i <= atom->nangletypes; i++) fprintf(fp,"%d %d %g %g %g %g %g %g\n", i,pflag[i],theta0[i]/MY_PI*180.0,k2[i],k3[i],k4[i],k5[i],k6[i]); + + fprintf(fp,"\nBondAngle Coeffs\n\n"); + for (int i = 1; i <= atom->nangletypes; i++) + fprintf(fp,"%d %g %g %g %g\n",i,ba_k1[i],ba_k2[i],ba_r1[i],ba_r2[i]); } /* ---------------------------------------------------------------------- */ @@ -526,5 +628,9 @@ double AngleAmoeba::single(int type, int i1, int i2, int i3) double energy = k2[type]*dtheta2 + k3[type]*dtheta3 + k4[type]*dtheta4 + k5[type]*dtheta5 + k6[type]*dtheta6; + double dr1 = r1 - ba_r1[type]; + double dr2 = r2 - ba_r2[type]; + energy += ba_k1[type]*dr1*dtheta + ba_k2[type]*dr2*dtheta; + return energy; } diff --git a/src/AMOEBA/angle_amoeba.h b/src/AMOEBA/angle_amoeba.h index 66a0c2c6b7..0fa50880e9 100644 --- a/src/AMOEBA/angle_amoeba.h +++ b/src/AMOEBA/angle_amoeba.h @@ -39,6 +39,8 @@ class AngleAmoeba : public Angle { protected: int *pflag; double *theta0, *k2, *k3, *k4, *k5, *k6; + double *ba_k1, *ba_k2, *ba_r1, *ba_r2; + int *setflag_a, *setflag_ba; void anglep(int, int, int, int, int); void allocate(); diff --git a/src/AMOEBA/improper_amoeba.cpp b/src/AMOEBA/improper_amoeba.cpp index d32b23ae2a..9741939241 100644 --- a/src/AMOEBA/improper_amoeba.cpp +++ b/src/AMOEBA/improper_amoeba.cpp @@ -17,9 +17,10 @@ #include #include "atom.h" #include "comm.h" +#include "update.h" #include "neighbor.h" #include "force.h" -#include "update.h" +#include "pair.h" #include "math_const.h" #include "memory.h" #include "error.h" @@ -56,7 +57,13 @@ void ImproperAmoeba::compute(int eflag, int vflag) double xab,yab,zab,xcb,ycb,zcb,xdb,ydb,zdb,xad,yad,zad,xcd,ycd,zcd; double rad2,rcd2,rdb2,dot,cc,ee; double sine,angle; - double eimproper,f1[3],f2[3],f3[3],f4[3]; + double dt,dt2,dt3,dt4,e; + double deddt,sign,dedcos,term; + double dccdxia,dccdyia,dccdzia,dccdxic,dccdyic,dccdzic; + double dccdxid,dccdyid,dccdzid; + double deedxia,deedyia,deedzia,deedxic,deedyic,deedzic; + double deedxid,deedyid,deedzid; + double eimproper,fa[3],fb[3],fc[3],fd[3]; eimproper = 0.0; ev_init(eflag,vflag); @@ -129,48 +136,91 @@ void ImproperAmoeba::compute(int eflag, int vflag) sine = fabs(ee) / sqrt(cc*rdb2); sine = MIN(1.0,sine); - angle = asin(sine) * MY_PI/180.0; + angle = 180.0/MY_PI * asin(sine); // angle = degrees - //dt = angle; - //dt2 = dt * dt; - //dt3 = dt2 * dt; - //dt4 = dt2 * dt2; - //e = opbunit * force * dt2 * (1.0d0+copb*dt+qopb*dt2+popb*dt3+sopb*dt4); - //deddt = opbunit * force * dt * radian * - // (2.0d0 + 3.0d0*copb*dt + 4.0d0*qopb*dt2 + 5.0d0*popb*dt3 + 6.0d0*sopb*dt4); - //dedcos = -deddt * sign(1.0d0,ee) / sqrt(cc*rdb2-ee*ee); + dt = angle; + dt2 = dt * dt; + dt3 = dt2 * dt; + dt4 = dt2 * dt2; + double prefactor = 1.0 / (180.0/MY_PI) / (180.0/MY_PI); + e = prefactor * k[type] * dt2 * (1.0 + opbend_cubic*dt + opbend_quartic*dt2 + + opbend_pentic*dt3 + opbend_sextic*dt4); + eimproper += e; + + deddt = k[type] * dt * + (2.0 + 3.0*opbend_cubic*dt + 4.0*opbend_quartic*dt2 + + 5.0*opbend_pentic*dt3 + 6.0*opbend_sextic*dt4); + sign = (ee >= 0.0) ? 1.0 : -1.0; + dedcos = -deddt * sign / sqrt(cc*rdb2 - ee*ee); + + // chain rule terms for first derivative components + + term = ee / cc; + dccdxia = (xad*rcd2-xcd*dot) * term; + dccdyia = (yad*rcd2-ycd*dot) * term; + dccdzia = (zad*rcd2-zcd*dot) * term; + dccdxic = (xcd*rad2-xad*dot) * term; + dccdyic = (ycd*rad2-yad*dot) * term; + dccdzic = (zcd*rad2-zad*dot) * term; + dccdxid = -dccdxia - dccdxic; + dccdyid = -dccdyia - dccdyic; + dccdzid = -dccdzia - dccdzic; + + term = ee / rdb2; + deedxia = ydb*zcb - zdb*ycb; + deedyia = zdb*xcb - xdb*zcb; + deedzia = xdb*ycb - ydb*xcb; + deedxic = yab*zdb - zab*ydb; + deedyic = zab*xdb - xab*zdb; + deedzic = xab*ydb - yab*xdb; + deedxid = ycb*zab - zcb*yab + xdb*term; + deedyid = zcb*xab - xcb*zab + ydb*term; + deedzid = xcb*yab - ycb*xab + zdb*term; + + // compute first derivative components for this angle + + fa[0] = dedcos * (dccdxia+deedxia); + fa[1] = dedcos * (dccdyia+deedyia); + fa[2] = dedcos * (dccdzia+deedzia); + fc[0] = dedcos * (dccdxic+deedxic); + fc[1] = dedcos * (dccdyic+deedyic); + fc[2] = dedcos * (dccdzic+deedzic); + fd[0] = dedcos * (dccdxid+deedxid); + fd[1] = dedcos * (dccdyid+deedyid); + fd[2] = dedcos * (dccdzid+deedzid); + fb[0] = -fa[0] - fc[0] - fd[0]; + fb[1] = -fa[1] - fc[1] - fd[1]; + fb[2] = -fa[1] - fc[2] - fd[2]; - /* // apply force to each of 4 atoms - if (newton_bond || i1 < nlocal) { - f[i1][0] += f1[0]; - f[i1][1] += f1[1]; - f[i1][2] += f1[2]; + if (newton_bond || id < nlocal) { + f[id][0] += fd[0]; + f[id][1] += fd[1]; + f[id][2] += fd[2]; } - if (newton_bond || i2 < nlocal) { - f[i2][0] += f2[0]; - f[i2][1] += f2[1]; - f[i2][2] += f2[2]; + if (newton_bond || ib < nlocal) { + f[ib][0] += fb[0]; + f[ib][1] += fb[1]; + f[ib][2] += fb[2]; } - if (newton_bond || i3 < nlocal) { - f[i3][0] += f3[0]; - f[i3][1] += f3[1]; - f[i3][2] += f3[2]; + if (newton_bond || ia < nlocal) { + f[ia][0] += fa[0]; + f[ia][1] += fa[1]; + f[ia][2] += fa[2]; } - if (newton_bond || i4 < nlocal) { - f[i4][0] += f4[0]; - f[i4][1] += f4[1]; - f[i4][2] += f4[2]; + if (newton_bond || ic < nlocal) { + f[ic][0] += fc[0]; + f[ic][1] += fc[1]; + f[ic][2] += fc[2]; } if (evflag) - ev_tally(i1,i2,i3,i4,nlocal,newton_bond,eimproper,f1,f3,f4, - vb1x,vb1y,vb1z,vb2x,vb2y,vb2z,vb3x,vb3y,vb3z); - */ + ev_tally(id,ib,ia,ic,nlocal,newton_bond,e,fd,fa,fc, + xdb,ydb,zdb,xab,yab,zab,xic-xia,yic-yia,zic-zia); } } @@ -213,6 +263,27 @@ void ImproperAmoeba::coeff(int narg, char **arg) if (count == 0) error->all(FLERR,"Incorrect args for improper coefficients"); } +/* ---------------------------------------------------------------------- + set opbend higher-order term weights from PairAmoeba +------------------------------------------------------------------------- */ + +void ImproperAmoeba::init_style() +{ + Pair *pair = force->pair_match("amoeba",1,0); + if (!pair) pair = force->pair_match("hippo",1,0); + if (!pair) error->all(FLERR,"Improper amoeba could not find pair amoega"); + + + int dim; + opbend_cubic = *(double *) pair->extract("opbend_cubic",dim); + opbend_quartic = *(double *) pair->extract("opbend_quartic",dim); + opbend_pentic = *(double *) pair->extract("opbend_pentic",dim); + opbend_sextic = *(double *) pair->extract("opbend_sextic",dim); + + printf("OPBEND %g %g %g %g\n", + opbend_cubic,opbend_quartic,opbend_pentic,opbend_sextic); +} + /* ---------------------------------------------------------------------- proc 0 writes out coeffs to restart file ------------------------------------------------------------------------- */ diff --git a/src/AMOEBA/improper_amoeba.h b/src/AMOEBA/improper_amoeba.h index 439a6c39fb..b25a60ac47 100644 --- a/src/AMOEBA/improper_amoeba.h +++ b/src/AMOEBA/improper_amoeba.h @@ -30,11 +30,13 @@ class ImproperAmoeba : public Improper { ~ImproperAmoeba(); void compute(int, int); void coeff(int, char **); + void init_style(); void write_restart(FILE *); void read_restart(FILE *); void write_data(FILE *); protected: + double opbend_cubic,opbend_quartic,opbend_pentic,opbend_sextic; double *k; virtual void allocate(); diff --git a/src/AMOEBA/pair_amoeba.cpp b/src/AMOEBA/pair_amoeba.cpp index f9e098e884..474a764f22 100644 --- a/src/AMOEBA/pair_amoeba.cpp +++ b/src/AMOEBA/pair_amoeba.cpp @@ -2107,6 +2107,18 @@ void PairAmoeba::zero_energy_force_virial() } } +/* ---------------------------------------------------------------------- */ + +void *PairAmoeba::extract(const char *str, int &dim) +{ + dim = 0; + if (strcmp(str,"opbend_cubic") == 0) return (void *) &opbend_cubic; + if (strcmp(str,"opbend_quartic") == 0) return (void *) &opbend_quartic; + if (strcmp(str,"opbend_pentic") == 0) return (void *) &opbend_pentic; + if (strcmp(str,"opbend_sextic") == 0) return (void *) &opbend_sextic; + return nullptr; +} + /* ---------------------------------------------------------------------- grow local vectors and arrays if necessary keep them atom->nmax in length diff --git a/src/AMOEBA/pair_amoeba.h b/src/AMOEBA/pair_amoeba.h index b28a00fb84..607c261695 100644 --- a/src/AMOEBA/pair_amoeba.h +++ b/src/AMOEBA/pair_amoeba.h @@ -57,6 +57,8 @@ class PairAmoeba : public Pair { void pack_reverse_grid(int, void *, int, int *); void unpack_reverse_grid(int, void *, int, int *); + void *extract(const char *, int &); + protected: int me,nprocs; int nmax; // allocation for owned+ghost From c479d7885472b3e80be82f868dc2604a471c6719 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Wed, 15 Dec 2021 16:34:28 -0700 Subject: [PATCH 055/585] add stretch-bend cross term --- examples/amoeba/data.ubiquitin | 8364 +++++++++++++++++--------------- examples/amoeba/in.ubiquitin | 1 + src/AMOEBA/angle_amoeba.cpp | 12 +- src/AMOEBA/improper_amoeba.cpp | 7 +- tools/tinker2lmp.py | 145 +- 5 files changed, 4682 insertions(+), 3847 deletions(-) diff --git a/examples/amoeba/data.ubiquitin b/examples/amoeba/data.ubiquitin index 49dd8b1a70..bf83af9f73 100644 --- a/examples/amoeba/data.ubiquitin +++ b/examples/amoeba/data.ubiquitin @@ -4,10 +4,12 @@ LAMMPS data file created from Tinker ubiquitin2.xyz and amoeba_ubiquitin2.prm fi 6908 bonds 5094 angles 3297 dihedrals +651 impropers 6 atom types 48 bond types 111 angle types 189 dihedral types +33 improper types 0 54.99 xlo xhi 0 41.91 ylo yhi 0 41.91 zlo zhi @@ -16677,298 +16679,298 @@ Angles 1 1 2 1 5 2 1 2 1 6 3 1 2 1 7 -4 2 5 1 6 -5 2 5 1 7 -6 2 6 1 7 -7 3 1 2 3 -8 4 1 2 8 -9 5 1 2 9 +4 2 6 1 5 +5 2 7 1 5 +6 2 7 1 6 +7 3 3 2 1 +8 4 8 2 1 +9 5 9 2 1 10 6 3 2 8 11 7 3 2 9 12 8 8 2 9 -13 9 2 3 4 -14 10 2 3 20 -15 11 4 3 20 +13 9 4 3 2 +14 10 20 3 2 +15 11 20 3 4 16 12 2 9 10 17 13 2 9 13 18 13 2 9 14 19 14 10 9 13 20 14 10 9 14 -21 15 13 9 14 +21 15 14 9 13 22 16 9 10 11 23 14 9 10 15 24 14 9 10 16 -25 17 11 10 15 -26 17 11 10 16 -27 15 15 10 16 -28 18 10 11 12 -29 19 11 12 17 -30 19 11 12 18 -31 19 11 12 19 -32 15 17 12 18 -33 15 17 12 19 -34 15 18 12 19 +25 17 15 10 11 +26 17 16 10 11 +27 15 16 10 15 +28 18 12 11 10 +29 19 17 12 11 +30 19 18 12 11 +31 19 19 12 11 +32 15 18 12 17 +33 15 19 12 17 +34 15 19 12 18 35 20 3 20 21 36 21 3 20 24 -37 22 21 20 24 +37 22 24 20 21 38 23 20 21 22 39 24 20 21 25 40 25 20 21 26 41 6 22 21 25 42 7 22 21 26 43 8 25 21 26 -44 9 21 22 23 -45 10 21 22 37 -46 11 23 22 37 +44 9 23 22 21 +45 10 37 22 21 +46 11 37 22 23 47 12 21 26 27 48 13 21 26 31 49 13 21 26 32 50 14 27 26 31 51 14 27 26 32 -52 15 31 26 32 -53 26 26 27 28 +52 15 32 26 31 +53 26 28 27 26 54 14 26 27 33 55 14 26 27 34 56 27 28 27 33 57 27 28 27 34 -58 15 33 27 34 -59 28 27 28 29 -60 29 27 28 30 -61 11 29 28 30 +58 15 34 27 33 +59 28 29 28 27 +60 29 30 28 27 +61 11 30 28 29 62 21 28 30 35 63 21 28 30 36 -64 30 35 30 36 +64 30 36 30 35 65 20 22 37 38 66 21 22 37 41 -67 22 38 37 41 +67 22 41 37 38 68 23 37 38 39 69 24 37 38 42 70 31 37 38 43 71 6 39 38 42 72 32 39 38 43 73 33 42 38 43 -74 9 38 39 40 -75 10 38 39 56 -76 11 40 39 56 +74 9 40 39 38 +75 10 56 39 38 +76 11 56 39 40 77 34 38 43 44 78 34 38 43 45 -79 33 38 43 47 -80 35 44 43 45 -81 8 44 43 47 -82 8 45 43 47 +79 33 47 43 38 +80 35 45 43 44 +81 8 47 43 44 +82 8 47 43 45 83 12 43 44 46 84 13 43 44 48 85 13 43 44 49 86 14 46 44 48 87 14 46 44 49 -88 15 48 44 49 +88 15 49 44 48 89 13 43 45 50 90 13 43 45 51 91 13 43 45 52 -92 15 50 45 51 -93 15 50 45 52 -94 15 51 45 52 +92 15 51 45 50 +93 15 52 45 50 +94 15 52 45 51 95 14 44 46 53 96 14 44 46 54 97 14 44 46 55 -98 15 53 46 54 -99 15 53 46 55 -100 15 54 46 55 +98 15 54 46 53 +99 15 55 46 53 +100 15 55 46 54 101 20 39 56 57 102 21 39 56 60 -103 22 57 56 60 +103 22 60 56 57 104 23 56 57 58 105 24 56 57 61 106 25 56 57 62 107 6 58 57 61 108 7 58 57 62 109 8 61 57 62 -110 9 57 58 59 -111 10 57 58 76 -112 11 59 58 76 +110 9 59 58 57 +111 10 76 58 57 +112 11 76 58 59 113 36 57 62 63 114 13 57 62 69 115 13 57 62 70 -116 37 63 62 69 -117 37 63 62 70 -118 15 69 62 70 +116 37 69 62 63 +117 37 70 62 63 +118 15 70 62 69 119 38 62 63 64 120 38 62 63 65 -121 39 64 63 65 -122 39 63 64 66 +121 39 65 63 64 +122 39 66 64 63 123 40 63 64 71 124 40 66 64 71 -125 39 63 65 67 +125 39 67 65 63 126 40 63 65 72 127 40 67 65 72 -128 39 64 66 68 +128 39 68 66 64 129 40 64 66 73 130 40 68 66 73 -131 39 65 67 68 +131 39 68 67 65 132 40 65 67 74 133 40 68 67 74 -134 39 66 68 67 +134 39 67 68 66 135 40 66 68 75 136 40 67 68 75 137 20 58 76 77 138 21 58 76 80 -139 22 77 76 80 +139 22 80 76 77 140 23 76 77 78 141 24 76 77 81 142 31 76 77 82 143 6 78 77 81 144 32 78 77 82 145 33 81 77 82 -146 9 77 78 79 -147 10 77 78 92 -148 11 79 78 92 +146 9 79 78 77 +147 10 92 78 77 +148 11 92 78 79 149 34 77 82 83 150 34 77 82 84 -151 33 77 82 85 -152 35 83 82 84 -153 8 83 82 85 -154 8 84 82 85 +151 33 85 82 77 +152 35 84 82 83 +153 8 85 82 83 +154 8 85 82 84 155 13 82 83 86 156 13 82 83 87 157 13 82 83 88 -158 15 86 83 87 -159 15 86 83 88 -160 15 87 83 88 +158 15 87 83 86 +159 15 88 83 86 +160 15 88 83 87 161 13 82 84 89 162 13 82 84 90 163 13 82 84 91 -164 15 89 84 90 -165 15 89 84 91 -166 15 90 84 91 +164 15 90 84 89 +165 15 91 84 89 +166 15 91 84 90 167 20 78 92 93 168 21 78 92 96 -169 22 93 92 96 +169 22 96 92 93 170 23 92 93 94 171 24 92 93 97 172 25 92 93 98 173 6 94 93 97 174 7 94 93 98 175 8 97 93 98 -176 9 93 94 95 -177 10 93 94 114 -178 11 95 94 114 +176 9 95 94 93 +177 10 114 94 93 +178 11 114 94 95 179 12 93 98 99 180 13 93 98 103 181 13 93 98 104 182 14 99 98 103 183 14 99 98 104 -184 15 103 98 104 -185 41 98 99 100 +184 15 104 98 103 +185 41 100 99 98 186 14 98 99 105 187 14 98 99 106 188 14 100 99 105 189 14 100 99 106 -190 15 105 99 106 -191 41 99 100 101 +190 15 106 99 105 +191 41 101 100 99 192 14 99 100 107 193 14 99 100 108 194 14 101 100 107 195 14 101 100 108 -196 15 107 100 108 +196 15 108 100 107 197 42 100 101 102 198 14 100 101 109 199 14 100 101 110 -200 43 102 101 109 -201 43 102 101 110 -202 15 109 101 110 +200 43 109 101 102 +201 43 110 101 102 +202 15 110 101 109 203 44 101 102 111 204 44 101 102 112 205 44 101 102 113 -206 45 111 102 112 -207 45 111 102 113 -208 45 112 102 113 +206 45 112 102 111 +207 45 113 102 111 +208 45 113 102 112 209 20 94 114 115 210 21 94 114 118 -211 22 115 114 118 +211 22 118 114 115 212 23 114 115 116 213 24 114 115 119 214 31 114 115 120 215 6 116 115 119 216 32 116 115 120 217 33 119 115 120 -218 9 115 116 117 -219 10 115 116 128 -220 11 117 116 128 +218 9 117 116 115 +219 10 128 116 115 +220 11 128 116 117 221 46 115 120 121 222 34 115 120 122 -223 33 115 120 123 -224 47 121 120 122 -225 48 121 120 123 -226 8 122 120 123 +223 33 123 120 115 +224 47 122 120 121 +225 48 123 120 121 +226 8 123 120 122 227 49 120 121 124 228 13 120 122 125 229 13 120 122 126 230 13 120 122 127 -231 15 125 122 126 -232 15 125 122 127 -233 15 126 122 127 +231 15 126 122 125 +232 15 127 122 125 +233 15 127 122 126 234 20 116 128 129 235 21 116 128 132 -236 22 129 128 132 +236 22 132 128 129 237 23 128 129 130 238 24 128 129 133 239 25 128 129 134 240 6 130 129 133 241 7 130 129 134 242 8 133 129 134 -243 9 129 130 131 -244 10 129 130 147 -245 11 131 130 147 -246 50 129 134 135 +243 9 131 130 129 +244 10 147 130 129 +245 11 147 130 131 +246 50 135 134 129 247 13 129 134 138 248 13 129 134 139 249 13 135 134 138 250 13 135 134 139 -251 15 138 134 139 -252 35 134 135 136 -253 35 134 135 137 -254 8 134 135 140 -255 35 136 135 137 -256 8 136 135 140 -257 8 137 135 140 +251 15 139 134 138 +252 35 136 135 134 +253 35 137 135 134 +254 8 140 135 134 +255 35 137 135 136 +256 8 140 135 136 +257 8 140 135 137 258 13 135 136 141 259 13 135 136 142 260 13 135 136 143 -261 15 141 136 142 -262 15 141 136 143 -263 15 142 136 143 +261 15 142 136 141 +262 15 143 136 141 +263 15 143 136 142 264 13 135 137 144 265 13 135 137 145 266 13 135 137 146 -267 15 144 137 145 -268 15 144 137 146 -269 15 145 137 146 +267 15 145 137 144 +268 15 146 137 144 +269 15 146 137 145 270 20 130 147 148 271 21 130 147 151 -272 22 148 147 151 +272 22 151 147 148 273 23 147 148 149 274 24 147 148 152 275 31 147 148 153 276 6 149 148 152 277 32 149 148 153 278 33 152 148 153 -279 9 148 149 150 -280 10 148 149 161 -281 11 150 149 161 +279 9 150 149 148 +280 10 161 149 148 +281 11 161 149 150 282 46 148 153 154 283 34 148 153 155 -284 33 148 153 156 -285 47 154 153 155 -286 48 154 153 156 -287 8 155 153 156 +284 33 156 153 148 +285 47 155 153 154 +286 48 156 153 154 +287 8 156 153 155 288 49 153 154 157 289 13 153 155 158 290 13 153 155 159 291 13 153 155 160 -292 15 158 155 159 -293 15 158 155 160 -294 15 159 155 160 -295 51 149 161 162 +292 15 159 155 158 +293 15 160 155 158 +294 15 160 155 159 +295 51 162 161 149 296 21 149 161 165 297 52 162 161 165 298 53 161 162 163 @@ -16976,241 +16978,241 @@ Angles 300 54 161 162 167 301 55 163 162 166 302 55 163 162 167 -303 56 166 162 167 +303 56 167 162 166 304 57 162 163 164 -305 58 162 163 168 -306 11 164 163 168 +305 58 168 163 162 +306 11 168 163 164 307 20 163 168 169 308 21 163 168 172 -309 22 169 168 172 +309 22 172 168 169 310 23 168 169 170 311 24 168 169 173 312 25 168 169 174 313 6 170 169 173 314 7 170 169 174 315 8 173 169 174 -316 9 169 170 171 -317 10 169 170 190 -318 11 171 170 190 +316 9 171 170 169 +317 10 190 170 169 +318 11 190 170 171 319 12 169 174 175 320 13 169 174 179 321 13 169 174 180 322 14 175 174 179 323 14 175 174 180 -324 15 179 174 180 -325 41 174 175 176 +324 15 180 174 179 +325 41 176 175 174 326 14 174 175 181 327 14 174 175 182 328 14 176 175 181 329 14 176 175 182 -330 15 181 175 182 -331 41 175 176 177 +330 15 182 175 181 +331 41 177 176 175 332 14 175 176 183 333 14 175 176 184 334 14 177 176 183 335 14 177 176 184 -336 15 183 176 184 +336 15 184 176 183 337 42 176 177 178 338 14 176 177 185 339 14 176 177 186 -340 43 178 177 185 -341 43 178 177 186 -342 15 185 177 186 +340 43 185 177 178 +341 43 186 177 178 +342 15 186 177 185 343 44 177 178 187 344 44 177 178 188 345 44 177 178 189 -346 45 187 178 188 -347 45 187 178 189 -348 45 188 178 189 +346 45 188 178 187 +347 45 189 178 187 +348 45 189 178 188 349 20 170 190 191 350 21 170 190 194 -351 22 191 190 194 +351 22 194 190 191 352 23 190 191 192 353 24 190 191 195 354 31 190 191 196 355 6 192 191 195 356 32 192 191 196 357 33 195 191 196 -358 9 191 192 193 -359 10 191 192 204 -360 11 193 192 204 +358 9 193 192 191 +359 10 204 192 191 +360 11 204 192 193 361 46 191 196 197 362 34 191 196 198 -363 33 191 196 199 -364 47 197 196 198 -365 48 197 196 199 -366 8 198 196 199 +363 33 199 196 191 +364 47 198 196 197 +365 48 199 196 197 +366 8 199 196 198 367 49 196 197 200 368 13 196 198 201 369 13 196 198 202 370 13 196 198 203 -371 15 201 198 202 -372 15 201 198 203 -373 15 202 198 203 +371 15 202 198 201 +372 15 203 198 201 +373 15 203 198 202 374 20 192 204 205 375 21 192 204 208 -376 22 205 204 208 +376 22 208 204 205 377 23 204 205 206 378 24 204 205 209 379 31 204 205 210 380 6 206 205 209 381 32 206 205 210 382 33 209 205 210 -383 9 205 206 207 -384 10 205 206 223 -385 11 207 206 223 +383 9 207 206 205 +384 10 223 206 205 +385 11 223 206 207 386 34 205 210 211 387 34 205 210 212 -388 33 205 210 214 -389 35 211 210 212 -390 8 211 210 214 -391 8 212 210 214 +388 33 214 210 205 +389 35 212 210 211 +390 8 214 210 211 +391 8 214 210 212 392 12 210 211 213 393 13 210 211 215 394 13 210 211 216 395 14 213 211 215 396 14 213 211 216 -397 15 215 211 216 +397 15 216 211 215 398 13 210 212 217 399 13 210 212 218 400 13 210 212 219 -401 15 217 212 218 -402 15 217 212 219 -403 15 218 212 219 +401 15 218 212 217 +402 15 219 212 217 +403 15 219 212 218 404 14 211 213 220 405 14 211 213 221 406 14 211 213 222 -407 15 220 213 221 -408 15 220 213 222 -409 15 221 213 222 +407 15 221 213 220 +408 15 222 213 220 +409 15 222 213 221 410 20 206 223 224 411 21 206 223 227 -412 22 224 223 227 +412 22 227 223 224 413 23 223 224 225 414 24 223 224 228 415 31 223 224 229 416 6 225 224 228 417 32 225 224 229 418 33 228 224 229 -419 9 224 225 226 -420 10 224 225 237 -421 11 226 225 237 +419 9 226 225 224 +420 10 237 225 224 +421 11 237 225 226 422 46 224 229 230 423 34 224 229 231 -424 33 224 229 232 -425 47 230 229 231 -426 48 230 229 232 -427 8 231 229 232 +424 33 232 229 224 +425 47 231 229 230 +426 48 232 229 230 +427 8 232 229 231 428 49 229 230 233 429 13 229 231 234 430 13 229 231 235 431 13 229 231 236 -432 15 234 231 235 -433 15 234 231 236 -434 15 235 231 236 +432 15 235 231 234 +433 15 236 231 234 +434 15 236 231 235 435 20 225 237 238 436 21 225 237 241 -437 22 238 237 241 +437 22 241 237 238 438 23 237 238 239 439 24 237 238 242 440 25 237 238 243 441 6 239 238 242 442 7 239 238 243 443 8 242 238 243 -444 9 238 239 240 -445 10 238 239 256 -446 11 240 239 256 -447 50 238 243 244 +444 9 240 239 238 +445 10 256 239 238 +446 11 256 239 240 +447 50 244 243 238 448 13 238 243 247 449 13 238 243 248 450 13 244 243 247 451 13 244 243 248 -452 15 247 243 248 -453 35 243 244 245 -454 35 243 244 246 -455 8 243 244 249 -456 35 245 244 246 -457 8 245 244 249 -458 8 246 244 249 +452 15 248 243 247 +453 35 245 244 243 +454 35 246 244 243 +455 8 249 244 243 +456 35 246 244 245 +457 8 249 244 245 +458 8 249 244 246 459 13 244 245 250 460 13 244 245 251 461 13 244 245 252 -462 15 250 245 251 -463 15 250 245 252 -464 15 251 245 252 +462 15 251 245 250 +463 15 252 245 250 +464 15 252 245 251 465 13 244 246 253 466 13 244 246 254 467 13 244 246 255 -468 15 253 246 254 -469 15 253 246 255 -470 15 254 246 255 +468 15 254 246 253 +469 15 255 246 253 +470 15 255 246 254 471 20 239 256 257 472 21 239 256 260 -473 22 257 256 260 +473 22 260 256 257 474 23 256 257 258 475 24 256 257 261 476 25 256 257 262 477 6 258 257 261 478 7 258 257 262 479 8 261 257 262 -480 9 257 258 259 -481 10 257 258 271 -482 11 259 258 271 +480 9 259 258 257 +481 10 271 258 257 +482 11 271 258 259 483 12 257 262 263 484 13 257 262 267 485 13 257 262 268 486 14 263 262 267 487 14 263 262 268 -488 15 267 262 268 +488 15 268 262 267 489 59 262 263 264 490 14 262 263 269 491 14 262 263 270 -492 60 264 263 269 -493 60 264 263 270 -494 15 269 263 270 +492 60 269 263 264 +493 60 270 263 264 +494 15 270 263 269 495 61 263 264 265 496 61 263 264 266 -497 62 265 264 266 +497 62 266 264 265 498 20 258 271 272 499 21 258 271 275 -500 22 272 271 275 +500 22 275 271 272 501 23 271 272 273 502 24 271 272 276 503 31 271 272 277 504 6 273 272 276 505 32 273 272 277 506 33 276 272 277 -507 9 272 273 274 -508 10 272 273 287 -509 11 274 273 287 +507 9 274 273 272 +508 10 287 273 272 +509 11 287 273 274 510 34 272 277 278 511 34 272 277 279 -512 33 272 277 280 -513 35 278 277 279 -514 8 278 277 280 -515 8 279 277 280 +512 33 280 277 272 +513 35 279 277 278 +514 8 280 277 278 +515 8 280 277 279 516 13 277 278 281 517 13 277 278 282 518 13 277 278 283 -519 15 281 278 282 -520 15 281 278 283 -521 15 282 278 283 +519 15 282 278 281 +520 15 283 278 281 +521 15 283 278 282 522 13 277 279 284 523 13 277 279 285 524 13 277 279 286 -525 15 284 279 285 -526 15 284 279 286 -527 15 285 279 286 +525 15 285 279 284 +526 15 286 279 284 +527 15 286 279 285 528 20 273 287 288 529 21 273 287 291 -530 22 288 287 291 +530 22 291 287 288 531 23 287 288 289 532 24 287 288 292 533 25 287 288 293 534 6 289 288 292 535 7 289 288 293 536 8 292 288 293 -537 9 288 289 290 +537 9 290 289 288 538 63 288 289 302 539 64 290 289 302 540 12 288 293 294 @@ -17218,487 +17220,487 @@ Angles 542 13 288 293 299 543 14 294 293 298 544 14 294 293 299 -545 15 298 293 299 +545 15 299 293 298 546 59 293 294 295 547 14 293 294 300 548 14 293 294 301 -549 60 295 294 300 -550 60 295 294 301 -551 15 300 294 301 +549 60 300 294 295 +550 60 301 294 295 +551 15 301 294 300 552 61 294 295 296 553 61 294 295 297 -554 62 296 295 297 +554 62 297 295 296 555 65 289 302 303 556 66 289 302 309 557 67 303 302 309 -558 68 302 303 304 -559 69 302 303 306 +558 68 304 303 302 +559 69 306 303 302 560 70 302 303 307 561 6 304 303 306 562 71 304 303 307 563 72 306 303 307 -564 9 303 304 305 -565 10 303 304 316 -566 11 305 304 316 +564 9 305 304 303 +565 10 316 304 303 +566 11 316 304 305 567 73 303 307 308 568 74 303 307 310 569 74 303 307 311 -570 75 308 307 310 -571 75 308 307 311 -572 76 310 307 311 -573 77 307 308 309 -574 75 307 308 312 -575 75 307 308 313 -576 75 309 308 312 -577 75 309 308 313 -578 76 312 308 313 +570 75 310 307 308 +571 75 311 307 308 +572 76 311 307 310 +573 77 309 308 307 +574 75 312 308 307 +575 75 313 308 307 +576 75 312 308 309 +577 75 313 308 309 +578 76 313 308 312 579 78 302 309 308 -580 79 302 309 314 -581 79 302 309 315 -582 80 308 309 314 -583 80 308 309 315 -584 81 314 309 315 +580 79 314 309 302 +581 79 315 309 302 +582 80 314 309 308 +583 80 315 309 308 +584 81 315 309 314 585 20 304 316 317 586 21 304 316 320 -587 22 317 316 320 +587 22 320 316 317 588 23 316 317 318 589 24 316 317 321 590 25 316 317 322 591 6 318 317 321 592 7 318 317 322 593 8 321 317 322 -594 9 317 318 319 -595 10 317 318 327 -596 11 319 318 327 +594 9 319 318 317 +595 10 327 318 317 +596 11 327 318 319 597 82 317 322 323 598 13 317 322 324 599 13 317 322 325 -600 83 323 322 324 -601 83 323 322 325 -602 15 324 322 325 +600 83 324 322 323 +601 83 325 322 323 +602 15 325 322 324 603 84 322 323 326 604 20 318 327 328 605 21 318 327 331 -606 22 328 327 331 +606 22 331 327 328 607 23 327 328 329 608 24 327 328 332 609 25 327 328 333 610 6 329 328 332 611 7 329 328 333 612 8 332 328 333 -613 9 328 329 330 -614 10 328 329 339 -615 11 330 329 339 +613 9 330 329 328 +614 10 339 329 328 +615 11 339 329 330 616 85 328 333 334 617 13 328 333 337 618 13 328 333 338 -619 60 334 333 337 -620 60 334 333 338 -621 15 337 333 338 +619 60 337 333 334 +620 60 338 333 334 +621 15 338 333 337 622 61 333 334 335 623 61 333 334 336 -624 62 335 334 336 +624 62 336 334 335 625 20 329 339 340 626 21 329 339 343 -627 22 340 339 343 +627 22 343 339 340 628 23 339 340 341 629 24 339 340 344 630 31 339 340 345 631 6 341 340 344 632 32 341 340 345 633 33 344 340 345 -634 9 340 341 342 -635 10 340 341 353 -636 11 342 341 353 +634 9 342 341 340 +635 10 353 341 340 +636 11 353 341 342 637 46 340 345 346 638 34 340 345 347 -639 33 340 345 348 -640 47 346 345 347 -641 48 346 345 348 -642 8 347 345 348 +639 33 348 345 340 +640 47 347 345 346 +641 48 348 345 346 +642 8 348 345 347 643 49 345 346 349 644 13 345 347 350 645 13 345 347 351 646 13 345 347 352 -647 15 350 347 351 -648 15 350 347 352 -649 15 351 347 352 +647 15 351 347 350 +648 15 352 347 350 +649 15 352 347 351 650 20 341 353 354 651 21 341 353 357 -652 22 354 353 357 +652 22 357 353 354 653 23 353 354 355 654 24 353 354 358 655 31 353 354 359 656 6 355 354 358 657 32 355 354 359 658 33 358 354 359 -659 9 354 355 356 -660 10 354 355 372 -661 11 356 355 372 +659 9 356 355 354 +660 10 372 355 354 +661 11 372 355 356 662 34 354 359 360 663 34 354 359 361 -664 33 354 359 363 -665 35 360 359 361 -666 8 360 359 363 -667 8 361 359 363 +664 33 363 359 354 +665 35 361 359 360 +666 8 363 359 360 +667 8 363 359 361 668 12 359 360 362 669 13 359 360 364 670 13 359 360 365 671 14 362 360 364 672 14 362 360 365 -673 15 364 360 365 +673 15 365 360 364 674 13 359 361 366 675 13 359 361 367 676 13 359 361 368 -677 15 366 361 367 -678 15 366 361 368 -679 15 367 361 368 +677 15 367 361 366 +678 15 368 361 366 +679 15 368 361 367 680 14 360 362 369 681 14 360 362 370 682 14 360 362 371 -683 15 369 362 370 -684 15 369 362 371 -685 15 370 362 371 +683 15 370 362 369 +684 15 371 362 369 +685 15 371 362 370 686 20 355 372 373 687 21 355 372 376 -688 22 373 372 376 +688 22 376 372 373 689 23 372 373 374 690 24 372 373 377 691 25 372 373 378 692 6 374 373 377 693 7 374 373 378 694 8 377 373 378 -695 9 373 374 375 -696 10 373 374 387 -697 11 375 374 387 +695 9 375 374 373 +696 10 387 374 373 +697 11 387 374 375 698 12 373 378 379 699 13 373 378 383 700 13 373 378 384 701 14 379 378 383 702 14 379 378 384 -703 15 383 378 384 +703 15 384 378 383 704 59 378 379 380 705 14 378 379 385 706 14 378 379 386 -707 60 380 379 385 -708 60 380 379 386 -709 15 385 379 386 +707 60 385 379 380 +708 60 386 379 380 +709 15 386 379 385 710 61 379 380 381 711 61 379 380 382 -712 62 381 380 382 +712 62 382 380 381 713 20 374 387 388 714 21 374 387 391 -715 22 388 387 391 +715 22 391 387 388 716 23 387 388 389 717 24 387 388 392 718 25 387 388 393 719 6 389 388 392 720 7 389 388 393 721 8 392 388 393 -722 9 388 389 390 -723 10 388 389 401 -724 11 390 389 401 -725 86 388 393 394 +722 9 390 389 388 +723 10 401 389 388 +724 11 401 389 390 +725 86 394 393 388 726 13 388 393 397 727 13 388 393 398 728 27 394 393 397 729 27 394 393 398 -730 15 397 393 398 -731 28 393 394 395 -732 29 393 394 396 -733 11 395 394 396 +730 15 398 393 397 +731 28 395 394 393 +732 29 396 394 393 +733 11 396 394 395 734 21 394 396 399 735 21 394 396 400 -736 30 399 396 400 +736 30 400 396 399 737 20 389 401 402 738 21 389 401 405 -739 22 402 401 405 +739 22 405 401 402 740 23 401 402 403 741 24 401 402 406 742 31 401 402 407 743 6 403 402 406 744 32 403 402 407 745 33 406 402 407 -746 9 402 403 404 -747 10 402 403 417 -748 11 404 403 417 +746 9 404 403 402 +747 10 417 403 402 +748 11 417 403 404 749 34 402 407 408 750 34 402 407 409 -751 33 402 407 410 -752 35 408 407 409 -753 8 408 407 410 -754 8 409 407 410 +751 33 410 407 402 +752 35 409 407 408 +753 8 410 407 408 +754 8 410 407 409 755 13 407 408 411 756 13 407 408 412 757 13 407 408 413 -758 15 411 408 412 -759 15 411 408 413 -760 15 412 408 413 +758 15 412 408 411 +759 15 413 408 411 +760 15 413 408 412 761 13 407 409 414 762 13 407 409 415 763 13 407 409 416 -764 15 414 409 415 -765 15 414 409 416 -766 15 415 409 416 +764 15 415 409 414 +765 15 416 409 414 +766 15 416 409 415 767 20 403 417 418 768 21 403 417 421 -769 22 418 417 421 +769 22 421 417 418 770 23 417 418 419 771 24 417 418 422 772 25 417 418 423 773 6 419 418 422 774 7 419 418 423 775 8 422 418 423 -776 9 418 419 420 -777 10 418 419 439 -778 11 420 419 439 +776 9 420 419 418 +777 10 439 419 418 +778 11 439 419 420 779 12 418 423 424 780 13 418 423 428 781 13 418 423 429 782 14 424 423 428 783 14 424 423 429 -784 15 428 423 429 -785 41 423 424 425 +784 15 429 423 428 +785 41 425 424 423 786 14 423 424 430 787 14 423 424 431 788 14 425 424 430 789 14 425 424 431 -790 15 430 424 431 -791 41 424 425 426 +790 15 431 424 430 +791 41 426 425 424 792 14 424 425 432 793 14 424 425 433 794 14 426 425 432 795 14 426 425 433 -796 15 432 425 433 +796 15 433 425 432 797 42 425 426 427 798 14 425 426 434 799 14 425 426 435 -800 43 427 426 434 -801 43 427 426 435 -802 15 434 426 435 +800 43 434 426 427 +801 43 435 426 427 +802 15 435 426 434 803 44 426 427 436 804 44 426 427 437 805 44 426 427 438 -806 45 436 427 437 -807 45 436 427 438 -808 45 437 427 438 +806 45 437 427 436 +807 45 438 427 436 +808 45 438 427 437 809 20 419 439 440 810 21 419 439 443 -811 22 440 439 443 +811 22 443 439 440 812 23 439 440 441 813 24 439 440 444 814 25 439 440 445 815 6 441 440 444 816 7 441 440 445 817 8 444 440 445 -818 9 440 441 442 -819 10 440 441 449 -820 11 442 441 449 +818 9 442 441 440 +819 10 449 441 440 +820 11 449 441 442 821 13 440 445 446 822 13 440 445 447 823 13 440 445 448 -824 15 446 445 447 -825 15 446 445 448 -826 15 447 445 448 +824 15 447 445 446 +825 15 448 445 446 +826 15 448 445 447 827 20 441 449 450 828 21 441 449 453 -829 22 450 449 453 +829 22 453 449 450 830 23 449 450 451 831 24 449 450 454 832 25 449 450 455 833 6 451 450 454 834 7 451 450 455 835 8 454 450 455 -836 9 450 451 452 -837 10 450 451 471 -838 11 452 451 471 +836 9 452 451 450 +837 10 471 451 450 +838 11 471 451 452 839 12 450 455 456 840 13 450 455 460 841 13 450 455 461 842 14 456 455 460 843 14 456 455 461 -844 15 460 455 461 -845 41 455 456 457 +844 15 461 455 460 +845 41 457 456 455 846 14 455 456 462 847 14 455 456 463 848 14 457 456 462 849 14 457 456 463 -850 15 462 456 463 -851 41 456 457 458 +850 15 463 456 462 +851 41 458 457 456 852 14 456 457 464 853 14 456 457 465 854 14 458 457 464 855 14 458 457 465 -856 15 464 457 465 +856 15 465 457 464 857 42 457 458 459 858 14 457 458 466 859 14 457 458 467 -860 43 459 458 466 -861 43 459 458 467 -862 15 466 458 467 +860 43 466 458 459 +861 43 467 458 459 +862 15 467 458 466 863 44 458 459 468 864 44 458 459 469 865 44 458 459 470 -866 45 468 459 469 -867 45 468 459 470 -868 45 469 459 470 +866 45 469 459 468 +867 45 470 459 468 +868 45 470 459 469 869 20 451 471 472 870 21 451 471 475 -871 22 472 471 475 +871 22 475 471 472 872 23 471 472 473 873 24 471 472 476 874 31 471 472 477 875 6 473 472 476 876 32 473 472 477 877 33 476 472 477 -878 9 472 473 474 -879 10 472 473 490 -880 11 474 473 490 +878 9 474 473 472 +879 10 490 473 472 +880 11 490 473 474 881 34 472 477 478 882 34 472 477 479 -883 33 472 477 481 -884 35 478 477 479 -885 8 478 477 481 -886 8 479 477 481 +883 33 481 477 472 +884 35 479 477 478 +885 8 481 477 478 +886 8 481 477 479 887 12 477 478 480 888 13 477 478 482 889 13 477 478 483 890 14 480 478 482 891 14 480 478 483 -892 15 482 478 483 +892 15 483 478 482 893 13 477 479 484 894 13 477 479 485 895 13 477 479 486 -896 15 484 479 485 -897 15 484 479 486 -898 15 485 479 486 +896 15 485 479 484 +897 15 486 479 484 +898 15 486 479 485 899 14 478 480 487 900 14 478 480 488 901 14 478 480 489 -902 15 487 480 488 -903 15 487 480 489 -904 15 488 480 489 +902 15 488 480 487 +903 15 489 480 487 +904 15 489 480 488 905 20 473 490 491 906 21 473 490 494 -907 22 491 490 494 +907 22 494 490 491 908 23 490 491 492 909 24 490 491 495 910 25 490 491 496 911 6 492 491 495 912 7 492 491 496 913 8 495 491 496 -914 9 491 492 493 -915 10 491 492 507 -916 11 493 492 507 +914 9 493 492 491 +915 10 507 492 491 +916 11 507 492 493 917 12 491 496 497 918 13 491 496 501 919 13 491 496 502 920 14 497 496 501 921 14 497 496 502 -922 15 501 496 502 -923 26 496 497 498 +922 15 502 496 501 +923 26 498 497 496 924 14 496 497 503 925 14 496 497 504 926 27 498 497 503 927 27 498 497 504 -928 15 503 497 504 -929 28 497 498 499 -930 29 497 498 500 -931 11 499 498 500 +928 15 504 497 503 +929 28 499 498 497 +930 29 500 498 497 +931 11 500 498 499 932 21 498 500 505 933 21 498 500 506 -934 30 505 500 506 +934 30 506 500 505 935 20 492 507 508 936 21 492 507 511 -937 22 508 507 511 +937 22 511 507 508 938 23 507 508 509 939 24 507 508 512 940 25 507 508 513 941 6 509 508 512 942 7 509 508 513 943 8 512 508 513 -944 9 508 509 510 -945 10 508 509 519 -946 11 510 509 519 +944 9 510 509 508 +945 10 519 509 508 +946 11 519 509 510 947 85 508 513 514 948 13 508 513 517 949 13 508 513 518 -950 60 514 513 517 -951 60 514 513 518 -952 15 517 513 518 +950 60 517 513 514 +951 60 518 513 514 +952 15 518 513 517 953 61 513 514 515 954 61 513 514 516 -955 62 515 514 516 +955 62 516 514 515 956 20 509 519 520 957 21 509 519 523 -958 22 520 519 523 +958 22 523 519 520 959 23 519 520 521 960 24 519 520 524 961 25 519 520 525 962 6 521 520 524 963 7 521 520 525 964 8 524 520 525 -965 9 520 521 522 -966 10 520 521 541 -967 11 522 521 541 +965 9 522 521 520 +966 10 541 521 520 +967 11 541 521 522 968 12 520 525 526 969 13 520 525 530 970 13 520 525 531 971 14 526 525 530 972 14 526 525 531 -973 15 530 525 531 -974 41 525 526 527 +973 15 531 525 530 +974 41 527 526 525 975 14 525 526 532 976 14 525 526 533 977 14 527 526 532 978 14 527 526 533 -979 15 532 526 533 -980 41 526 527 528 +979 15 533 526 532 +980 41 528 527 526 981 14 526 527 534 982 14 526 527 535 983 14 528 527 534 984 14 528 527 535 -985 15 534 527 535 +985 15 535 527 534 986 42 527 528 529 987 14 527 528 536 988 14 527 528 537 -989 43 529 528 536 -990 43 529 528 537 -991 15 536 528 537 +989 43 536 528 529 +990 43 537 528 529 +991 15 537 528 536 992 44 528 529 538 993 44 528 529 539 994 44 528 529 540 -995 45 538 529 539 -996 45 538 529 540 -997 45 539 529 540 +995 45 539 529 538 +996 45 540 529 538 +997 45 540 529 539 998 20 521 541 542 999 21 521 541 545 -1000 22 542 541 545 +1000 22 545 541 542 1001 23 541 542 543 1002 24 541 542 546 1003 25 541 542 547 1004 6 543 542 546 1005 7 543 542 547 1006 8 546 542 547 -1007 9 542 543 544 -1008 10 542 543 556 -1009 11 544 543 556 +1007 9 544 543 542 +1008 10 556 543 542 +1009 11 556 543 544 1010 12 542 547 548 1011 13 542 547 552 1012 13 542 547 553 1013 14 548 547 552 1014 14 548 547 553 -1015 15 552 547 553 +1015 15 553 547 552 1016 59 547 548 549 1017 14 547 548 554 1018 14 547 548 555 -1019 60 549 548 554 -1020 60 549 548 555 -1021 15 554 548 555 +1019 60 554 548 549 +1020 60 555 548 549 +1021 15 555 548 554 1022 61 548 549 550 1023 61 548 549 551 -1024 62 550 549 551 -1025 51 543 556 557 +1024 62 551 549 550 +1025 51 557 556 543 1026 21 543 556 560 1027 52 557 556 560 1028 53 556 557 558 @@ -17706,356 +17708,356 @@ Angles 1030 54 556 557 562 1031 55 558 557 561 1032 55 558 557 562 -1033 56 561 557 562 +1033 56 562 557 561 1034 57 557 558 559 -1035 58 557 558 563 -1036 11 559 558 563 +1035 58 563 558 557 +1036 11 563 558 559 1037 20 558 563 564 1038 21 558 563 567 -1039 22 564 563 567 +1039 22 567 563 564 1040 23 563 564 565 1041 24 563 564 568 1042 31 563 564 569 1043 6 565 564 568 1044 32 565 564 569 1045 33 568 564 569 -1046 9 564 565 566 +1046 9 566 565 564 1047 63 564 565 582 1048 64 566 565 582 1049 34 564 569 570 1050 34 564 569 571 -1051 33 564 569 573 -1052 35 570 569 571 -1053 8 570 569 573 -1054 8 571 569 573 +1051 33 573 569 564 +1052 35 571 569 570 +1053 8 573 569 570 +1054 8 573 569 571 1055 12 569 570 572 1056 13 569 570 574 1057 13 569 570 575 1058 14 572 570 574 1059 14 572 570 575 -1060 15 574 570 575 +1060 15 575 570 574 1061 13 569 571 576 1062 13 569 571 577 1063 13 569 571 578 -1064 15 576 571 577 -1065 15 576 571 578 -1066 15 577 571 578 +1064 15 577 571 576 +1065 15 578 571 576 +1066 15 578 571 577 1067 14 570 572 579 1068 14 570 572 580 1069 14 570 572 581 -1070 15 579 572 580 -1071 15 579 572 581 -1072 15 580 572 581 +1070 15 580 572 579 +1071 15 581 572 579 +1072 15 581 572 580 1073 65 565 582 583 1074 66 565 582 589 1075 67 583 582 589 -1076 68 582 583 584 -1077 69 582 583 586 +1076 68 584 583 582 +1077 69 586 583 582 1078 70 582 583 587 1079 6 584 583 586 1080 71 584 583 587 1081 72 586 583 587 -1082 9 583 584 585 +1082 9 585 584 583 1083 63 583 584 596 1084 64 585 584 596 1085 73 583 587 588 1086 74 583 587 590 1087 74 583 587 591 -1088 75 588 587 590 -1089 75 588 587 591 -1090 76 590 587 591 -1091 77 587 588 589 -1092 75 587 588 592 -1093 75 587 588 593 -1094 75 589 588 592 -1095 75 589 588 593 -1096 76 592 588 593 +1088 75 590 587 588 +1089 75 591 587 588 +1090 76 591 587 590 +1091 77 589 588 587 +1092 75 592 588 587 +1093 75 593 588 587 +1094 75 592 588 589 +1095 75 593 588 589 +1096 76 593 588 592 1097 78 582 589 588 -1098 79 582 589 594 -1099 79 582 589 595 -1100 80 588 589 594 -1101 80 588 589 595 -1102 81 594 589 595 +1098 79 594 589 582 +1099 79 595 589 582 +1100 80 594 589 588 +1101 80 595 589 588 +1102 81 595 589 594 1103 65 584 596 597 1104 66 584 596 603 1105 67 597 596 603 -1106 68 596 597 598 -1107 69 596 597 600 +1106 68 598 597 596 +1107 69 600 597 596 1108 70 596 597 601 1109 6 598 597 600 1110 71 598 597 601 1111 72 600 597 601 -1112 9 597 598 599 -1113 10 597 598 610 -1114 11 599 598 610 +1112 9 599 598 597 +1113 10 610 598 597 +1114 11 610 598 599 1115 73 597 601 602 1116 74 597 601 604 1117 74 597 601 605 -1118 75 602 601 604 -1119 75 602 601 605 -1120 76 604 601 605 -1121 77 601 602 603 -1122 75 601 602 606 -1123 75 601 602 607 -1124 75 603 602 606 -1125 75 603 602 607 -1126 76 606 602 607 +1118 75 604 601 602 +1119 75 605 601 602 +1120 76 605 601 604 +1121 77 603 602 601 +1122 75 606 602 601 +1123 75 607 602 601 +1124 75 606 602 603 +1125 75 607 602 603 +1126 76 607 602 606 1127 78 596 603 602 -1128 79 596 603 608 -1129 79 596 603 609 -1130 80 602 603 608 -1131 80 602 603 609 -1132 81 608 603 609 +1128 79 608 603 596 +1129 79 609 603 596 +1130 80 608 603 602 +1131 80 609 603 602 +1132 81 609 603 608 1133 20 598 610 611 1134 21 598 610 614 -1135 22 611 610 614 +1135 22 614 610 611 1136 23 610 611 612 1137 24 610 611 615 1138 25 610 611 616 1139 6 612 611 615 1140 7 612 611 616 1141 8 615 611 616 -1142 9 611 612 613 -1143 10 611 612 622 -1144 11 613 612 622 +1142 9 613 612 611 +1143 10 622 612 611 +1144 11 622 612 613 1145 85 611 616 617 1146 13 611 616 620 1147 13 611 616 621 -1148 60 617 616 620 -1149 60 617 616 621 -1150 15 620 616 621 +1148 60 620 616 617 +1149 60 621 616 617 +1150 15 621 616 620 1151 61 616 617 618 1152 61 616 617 619 -1153 62 618 617 619 +1153 62 619 617 618 1154 20 612 622 623 1155 21 612 622 626 -1156 22 623 622 626 +1156 22 626 622 623 1157 23 622 623 624 1158 24 622 623 627 1159 25 622 623 628 1160 6 624 623 627 1161 7 624 623 628 1162 8 627 623 628 -1163 9 623 624 625 -1164 10 623 624 639 -1165 11 625 624 639 +1163 9 625 624 623 +1164 10 639 624 623 +1165 11 639 624 625 1166 12 623 628 629 1167 13 623 628 633 1168 13 623 628 634 1169 14 629 628 633 1170 14 629 628 634 -1171 15 633 628 634 -1172 26 628 629 630 +1171 15 634 628 633 +1172 26 630 629 628 1173 14 628 629 635 1174 14 628 629 636 1175 27 630 629 635 1176 27 630 629 636 -1177 15 635 629 636 -1178 28 629 630 631 -1179 29 629 630 632 -1180 11 631 630 632 +1177 15 636 629 635 +1178 28 631 630 629 +1179 29 632 630 629 +1180 11 632 630 631 1181 21 630 632 637 1182 21 630 632 638 -1183 30 637 632 638 +1183 30 638 632 637 1184 20 624 639 640 1185 21 624 639 643 -1186 22 640 639 643 +1186 22 643 639 640 1187 23 639 640 641 1188 24 639 640 644 1189 25 639 640 645 1190 6 641 640 644 1191 7 641 640 645 1192 8 644 640 645 -1193 9 640 641 642 -1194 10 640 641 656 -1195 11 642 641 656 +1193 9 642 641 640 +1194 10 656 641 640 +1195 11 656 641 642 1196 12 640 645 646 1197 13 640 645 650 1198 13 640 645 651 1199 14 646 645 650 1200 14 646 645 651 -1201 15 650 645 651 -1202 26 645 646 647 +1201 15 651 645 650 +1202 26 647 646 645 1203 14 645 646 652 1204 14 645 646 653 1205 27 647 646 652 1206 27 647 646 653 -1207 15 652 646 653 -1208 28 646 647 648 -1209 29 646 647 649 -1210 11 648 647 649 +1207 15 653 646 652 +1208 28 648 647 646 +1209 29 649 647 646 +1210 11 649 647 648 1211 21 647 649 654 1212 21 647 649 655 -1213 30 654 649 655 +1213 30 655 649 654 1214 20 641 656 657 1215 21 641 656 660 -1216 22 657 656 660 +1216 22 660 656 657 1217 23 656 657 658 1218 24 656 657 661 1219 25 656 657 662 1220 6 658 657 661 1221 7 658 657 662 1222 8 661 657 662 -1223 9 657 658 659 -1224 10 657 658 680 -1225 11 659 658 680 +1223 9 659 658 657 +1224 10 680 658 657 +1225 11 680 658 659 1226 12 657 662 663 1227 13 657 662 669 1228 13 657 662 670 1229 14 663 662 669 1230 14 663 662 670 -1231 15 669 662 670 -1232 41 662 663 664 +1231 15 670 662 669 +1232 41 664 663 662 1233 14 662 663 671 1234 14 662 663 672 1235 14 664 663 671 1236 14 664 663 672 -1237 15 671 663 672 -1238 87 663 664 665 +1237 15 672 663 671 +1238 87 665 664 663 1239 14 663 664 673 1240 14 663 664 674 1241 88 665 664 673 1242 88 665 664 674 -1243 15 673 664 674 +1243 15 674 664 673 1244 89 664 665 666 1245 90 664 665 675 -1246 91 666 665 675 -1247 92 665 666 667 -1248 92 665 666 668 -1249 92 667 666 668 -1250 91 666 667 676 -1251 91 666 667 677 -1252 93 676 667 677 -1253 91 666 668 678 -1254 91 666 668 679 -1255 93 678 668 679 +1246 91 675 665 666 +1247 92 667 666 665 +1248 92 668 666 665 +1249 92 668 666 667 +1250 91 676 667 666 +1251 91 677 667 666 +1252 93 677 667 676 +1253 91 678 668 666 +1254 91 679 668 666 +1255 93 679 668 678 1256 20 658 680 681 1257 21 658 680 684 -1258 22 681 680 684 +1258 22 684 680 681 1259 23 680 681 682 1260 24 680 681 685 1261 25 680 681 686 1262 6 682 681 685 1263 7 682 681 686 1264 8 685 681 686 -1265 9 681 682 683 -1266 10 681 682 699 -1267 11 683 682 699 -1268 50 681 686 687 +1265 9 683 682 681 +1266 10 699 682 681 +1267 11 699 682 683 +1268 50 687 686 681 1269 13 681 686 690 1270 13 681 686 691 1271 13 687 686 690 1272 13 687 686 691 -1273 15 690 686 691 -1274 35 686 687 688 -1275 35 686 687 689 -1276 8 686 687 692 -1277 35 688 687 689 -1278 8 688 687 692 -1279 8 689 687 692 +1273 15 691 686 690 +1274 35 688 687 686 +1275 35 689 687 686 +1276 8 692 687 686 +1277 35 689 687 688 +1278 8 692 687 688 +1279 8 692 687 689 1280 13 687 688 693 1281 13 687 688 694 1282 13 687 688 695 -1283 15 693 688 694 -1284 15 693 688 695 -1285 15 694 688 695 +1283 15 694 688 693 +1284 15 695 688 693 +1285 15 695 688 694 1286 13 687 689 696 1287 13 687 689 697 1288 13 687 689 698 -1289 15 696 689 697 -1290 15 696 689 698 -1291 15 697 689 698 +1289 15 697 689 696 +1290 15 698 689 696 +1291 15 698 689 697 1292 20 682 699 700 1293 21 682 699 703 -1294 22 700 699 703 +1294 22 703 699 700 1295 23 699 700 701 1296 24 699 700 704 1297 31 699 700 705 1298 6 701 700 704 1299 32 701 700 705 1300 33 704 700 705 -1301 9 700 701 702 -1302 10 700 701 718 -1303 11 702 701 718 +1301 9 702 701 700 +1302 10 718 701 700 +1303 11 718 701 702 1304 34 700 705 706 1305 34 700 705 707 -1306 33 700 705 709 -1307 35 706 705 707 -1308 8 706 705 709 -1309 8 707 705 709 +1306 33 709 705 700 +1307 35 707 705 706 +1308 8 709 705 706 +1309 8 709 705 707 1310 12 705 706 708 1311 13 705 706 710 1312 13 705 706 711 1313 14 708 706 710 1314 14 708 706 711 -1315 15 710 706 711 +1315 15 711 706 710 1316 13 705 707 712 1317 13 705 707 713 1318 13 705 707 714 -1319 15 712 707 713 -1320 15 712 707 714 -1321 15 713 707 714 +1319 15 713 707 712 +1320 15 714 707 712 +1321 15 714 707 713 1322 14 706 708 715 1323 14 706 708 716 1324 14 706 708 717 -1325 15 715 708 716 -1326 15 715 708 717 -1327 15 716 708 717 +1325 15 716 708 715 +1326 15 717 708 715 +1327 15 717 708 716 1328 20 701 718 719 1329 21 701 718 722 -1330 22 719 718 722 +1330 22 722 718 719 1331 23 718 719 720 1332 24 718 719 723 1333 25 718 719 724 1334 6 720 719 723 1335 7 720 719 724 1336 8 723 719 724 -1337 9 719 720 721 -1338 10 719 720 738 -1339 11 721 720 738 +1337 9 721 720 719 +1338 10 738 720 719 +1339 11 738 720 721 1340 36 719 724 725 1341 13 719 724 731 1342 13 719 724 732 -1343 37 725 724 731 -1344 37 725 724 732 -1345 15 731 724 732 +1343 37 731 724 725 +1344 37 732 724 725 +1345 15 732 724 731 1346 38 724 725 726 1347 38 724 725 727 -1348 39 726 725 727 -1349 39 725 726 728 +1348 39 727 725 726 +1349 39 728 726 725 1350 40 725 726 733 1351 40 728 726 733 -1352 39 725 727 729 +1352 39 729 727 725 1353 40 725 727 734 1354 40 729 727 734 -1355 39 726 728 730 +1355 39 730 728 726 1356 40 726 728 735 1357 40 730 728 735 -1358 39 727 729 730 +1358 39 730 729 727 1359 40 727 729 736 1360 40 730 729 736 -1361 39 728 730 729 +1361 39 729 730 728 1362 40 728 730 737 1363 40 729 730 737 1364 20 720 738 739 1365 21 720 738 742 -1366 22 739 738 742 +1366 22 742 738 739 1367 23 738 739 740 1368 24 738 739 743 1369 25 738 739 744 1370 6 740 739 743 1371 7 740 739 744 1372 8 743 739 744 -1373 9 739 740 741 -1374 10 739 740 748 -1375 11 741 740 748 +1373 9 741 740 739 +1374 10 748 740 739 +1375 11 748 740 741 1376 13 739 744 745 1377 13 739 744 746 1378 13 739 744 747 -1379 15 745 744 746 -1380 15 745 744 747 -1381 15 746 744 747 -1382 51 740 748 749 +1379 15 746 744 745 +1380 15 747 744 745 +1381 15 747 744 746 +1382 51 749 748 740 1383 21 740 748 752 1384 52 749 748 752 1385 53 748 749 750 @@ -18063,167 +18065,167 @@ Angles 1387 54 748 749 754 1388 55 750 749 753 1389 55 750 749 754 -1390 56 753 749 754 +1390 56 754 749 753 1391 57 749 750 751 -1392 58 749 750 755 -1393 11 751 750 755 +1392 58 755 750 749 +1393 11 755 750 751 1394 20 750 755 756 1395 21 750 755 759 -1396 22 756 755 759 +1396 22 759 755 756 1397 23 755 756 757 1398 24 755 756 760 1399 25 755 756 761 1400 6 757 756 760 1401 7 757 756 761 1402 8 760 756 761 -1403 9 756 757 758 -1404 10 756 757 777 -1405 11 758 757 777 +1403 9 758 757 756 +1404 10 777 757 756 +1405 11 777 757 758 1406 12 756 761 762 1407 13 756 761 766 1408 13 756 761 767 1409 14 762 761 766 1410 14 762 761 767 -1411 15 766 761 767 -1412 41 761 762 763 +1411 15 767 761 766 +1412 41 763 762 761 1413 14 761 762 768 1414 14 761 762 769 1415 14 763 762 768 1416 14 763 762 769 -1417 15 768 762 769 -1418 41 762 763 764 +1417 15 769 762 768 +1418 41 764 763 762 1419 14 762 763 770 1420 14 762 763 771 1421 14 764 763 770 1422 14 764 763 771 -1423 15 770 763 771 +1423 15 771 763 770 1424 42 763 764 765 1425 14 763 764 772 1426 14 763 764 773 -1427 43 765 764 772 -1428 43 765 764 773 -1429 15 772 764 773 +1427 43 772 764 765 +1428 43 773 764 765 +1429 15 773 764 772 1430 44 764 765 774 1431 44 764 765 775 1432 44 764 765 776 -1433 45 774 765 775 -1434 45 774 765 776 -1435 45 775 765 776 +1433 45 775 765 774 +1434 45 776 765 774 +1435 45 776 765 775 1436 20 757 777 778 1437 21 757 777 781 -1438 22 778 777 781 +1438 22 781 777 778 1439 23 777 778 779 1440 24 777 778 782 1441 25 777 778 783 1442 6 779 778 782 1443 7 779 778 783 1444 8 782 778 783 -1445 9 778 779 780 -1446 10 778 779 794 -1447 11 780 779 794 +1445 9 780 779 778 +1446 10 794 779 778 +1447 11 794 779 780 1448 12 778 783 784 1449 13 778 783 788 1450 13 778 783 789 1451 14 784 783 788 1452 14 784 783 789 -1453 15 788 783 789 -1454 26 783 784 785 +1453 15 789 783 788 +1454 26 785 784 783 1455 14 783 784 790 1456 14 783 784 791 1457 27 785 784 790 1458 27 785 784 791 -1459 15 790 784 791 -1460 28 784 785 786 -1461 29 784 785 787 -1462 11 786 785 787 +1459 15 791 784 790 +1460 28 786 785 784 +1461 29 787 785 784 +1462 11 787 785 786 1463 21 785 787 792 1464 21 785 787 793 -1465 30 792 787 793 +1465 30 793 787 792 1466 20 779 794 795 1467 21 779 794 798 -1468 22 795 794 798 +1468 22 798 794 795 1469 23 794 795 796 1470 24 794 795 799 1471 25 794 795 800 1472 6 796 795 799 1473 7 796 795 800 1474 8 799 795 800 -1475 9 795 796 797 -1476 10 795 796 813 -1477 11 797 796 813 -1478 50 795 800 801 +1475 9 797 796 795 +1476 10 813 796 795 +1477 11 813 796 797 +1478 50 801 800 795 1479 13 795 800 804 1480 13 795 800 805 1481 13 801 800 804 1482 13 801 800 805 -1483 15 804 800 805 -1484 35 800 801 802 -1485 35 800 801 803 -1486 8 800 801 806 -1487 35 802 801 803 -1488 8 802 801 806 -1489 8 803 801 806 +1483 15 805 800 804 +1484 35 802 801 800 +1485 35 803 801 800 +1486 8 806 801 800 +1487 35 803 801 802 +1488 8 806 801 802 +1489 8 806 801 803 1490 13 801 802 807 1491 13 801 802 808 1492 13 801 802 809 -1493 15 807 802 808 -1494 15 807 802 809 -1495 15 808 802 809 +1493 15 808 802 807 +1494 15 809 802 807 +1495 15 809 802 808 1496 13 801 803 810 1497 13 801 803 811 1498 13 801 803 812 -1499 15 810 803 811 -1500 15 810 803 812 -1501 15 811 803 812 +1499 15 811 803 810 +1500 15 812 803 810 +1501 15 812 803 811 1502 20 796 813 814 1503 21 796 813 817 -1504 22 814 813 817 +1504 22 817 813 814 1505 23 813 814 815 1506 24 813 814 818 1507 25 813 814 819 1508 6 815 814 818 1509 7 815 814 819 1510 8 818 814 819 -1511 9 814 815 816 -1512 10 814 815 828 -1513 11 816 815 828 +1511 9 816 815 814 +1512 10 828 815 814 +1513 11 828 815 816 1514 12 814 819 820 1515 13 814 819 824 1516 13 814 819 825 1517 14 820 819 824 1518 14 820 819 825 -1519 15 824 819 825 +1519 15 825 819 824 1520 59 819 820 821 1521 14 819 820 826 1522 14 819 820 827 -1523 60 821 820 826 -1524 60 821 820 827 -1525 15 826 820 827 +1523 60 826 820 821 +1524 60 827 820 821 +1525 15 827 820 826 1526 61 820 821 822 1527 61 820 821 823 -1528 62 822 821 823 +1528 62 823 821 822 1529 20 815 828 829 1530 21 815 828 832 -1531 22 829 828 832 +1531 22 832 828 829 1532 23 828 829 830 1533 24 828 829 833 1534 25 828 829 834 1535 6 830 829 833 1536 7 830 829 834 1537 8 833 829 834 -1538 9 829 830 831 -1539 10 829 830 840 -1540 11 831 830 840 +1538 9 831 830 829 +1539 10 840 830 829 +1540 11 840 830 831 1541 85 829 834 835 1542 13 829 834 838 1543 13 829 834 839 -1544 60 835 834 838 -1545 60 835 834 839 -1546 15 838 834 839 +1544 60 838 834 835 +1545 60 839 834 835 +1546 15 839 834 838 1547 61 834 835 836 1548 61 834 835 837 -1549 62 836 835 837 -1550 51 830 840 841 +1549 62 837 835 836 +1550 51 841 840 830 1551 21 830 840 844 1552 52 841 840 844 1553 53 840 841 842 @@ -18231,685 +18233,685 @@ Angles 1555 54 840 841 846 1556 55 842 841 845 1557 55 842 841 846 -1558 56 845 841 846 +1558 56 846 841 845 1559 57 841 842 843 -1560 58 841 842 847 -1561 11 843 842 847 +1560 58 847 842 841 +1561 11 847 842 843 1562 20 842 847 848 1563 21 842 847 851 -1564 22 848 847 851 +1564 22 851 847 848 1565 23 847 848 849 1566 24 847 848 852 1567 25 847 848 853 1568 6 849 848 852 1569 7 849 848 853 1570 8 852 848 853 -1571 9 848 849 850 -1572 10 848 849 871 -1573 11 850 849 871 +1571 9 850 849 848 +1572 10 871 849 848 +1573 11 871 849 850 1574 12 848 853 854 1575 13 848 853 860 1576 13 848 853 861 1577 14 854 853 860 1578 14 854 853 861 -1579 15 860 853 861 -1580 41 853 854 855 +1579 15 861 853 860 +1580 41 855 854 853 1581 14 853 854 862 1582 14 853 854 863 1583 14 855 854 862 1584 14 855 854 863 -1585 15 862 854 863 -1586 87 854 855 856 +1585 15 863 854 862 +1586 87 856 855 854 1587 14 854 855 864 1588 14 854 855 865 1589 88 856 855 864 1590 88 856 855 865 -1591 15 864 855 865 +1591 15 865 855 864 1592 89 855 856 857 1593 90 855 856 866 -1594 91 857 856 866 -1595 92 856 857 858 -1596 92 856 857 859 -1597 92 858 857 859 -1598 91 857 858 867 -1599 91 857 858 868 -1600 93 867 858 868 -1601 91 857 859 869 -1602 91 857 859 870 -1603 93 869 859 870 +1594 91 866 856 857 +1595 92 858 857 856 +1596 92 859 857 856 +1597 92 859 857 858 +1598 91 867 858 857 +1599 91 868 858 857 +1600 93 868 858 867 +1601 91 869 859 857 +1602 91 870 859 857 +1603 93 870 859 869 1604 20 849 871 872 1605 21 849 871 875 -1606 22 872 871 875 +1606 22 875 871 872 1607 23 871 872 873 1608 24 871 872 876 1609 31 871 872 877 1610 6 873 872 876 1611 32 873 872 877 1612 33 876 872 877 -1613 9 872 873 874 -1614 10 872 873 885 -1615 11 874 873 885 +1613 9 874 873 872 +1614 10 885 873 872 +1615 11 885 873 874 1616 46 872 877 878 1617 34 872 877 879 -1618 33 872 877 880 -1619 47 878 877 879 -1620 48 878 877 880 -1621 8 879 877 880 +1618 33 880 877 872 +1619 47 879 877 878 +1620 48 880 877 878 +1621 8 880 877 879 1622 49 877 878 881 1623 13 877 879 882 1624 13 877 879 883 1625 13 877 879 884 -1626 15 882 879 883 -1627 15 882 879 884 -1628 15 883 879 884 +1626 15 883 879 882 +1627 15 884 879 882 +1628 15 884 879 883 1629 20 873 885 886 1630 21 873 885 889 -1631 22 886 885 889 +1631 22 889 885 886 1632 23 885 886 887 1633 24 885 886 890 1634 25 885 886 891 1635 6 887 886 890 1636 7 887 886 891 1637 8 890 886 891 -1638 9 886 887 888 -1639 10 886 887 904 -1640 11 888 887 904 -1641 50 886 891 892 +1638 9 888 887 886 +1639 10 904 887 886 +1640 11 904 887 888 +1641 50 892 891 886 1642 13 886 891 895 1643 13 886 891 896 1644 13 892 891 895 1645 13 892 891 896 -1646 15 895 891 896 -1647 35 891 892 893 -1648 35 891 892 894 -1649 8 891 892 897 -1650 35 893 892 894 -1651 8 893 892 897 -1652 8 894 892 897 +1646 15 896 891 895 +1647 35 893 892 891 +1648 35 894 892 891 +1649 8 897 892 891 +1650 35 894 892 893 +1651 8 897 892 893 +1652 8 897 892 894 1653 13 892 893 898 1654 13 892 893 899 1655 13 892 893 900 -1656 15 898 893 899 -1657 15 898 893 900 -1658 15 899 893 900 +1656 15 899 893 898 +1657 15 900 893 898 +1658 15 900 893 899 1659 13 892 894 901 1660 13 892 894 902 1661 13 892 894 903 -1662 15 901 894 902 -1663 15 901 894 903 -1664 15 902 894 903 +1662 15 902 894 901 +1663 15 903 894 901 +1664 15 903 894 902 1665 20 887 904 905 1666 21 887 904 908 -1667 22 905 904 908 +1667 22 908 904 905 1668 23 904 905 906 1669 24 904 905 909 1670 25 904 905 910 1671 6 906 905 909 1672 7 906 905 910 1673 8 909 905 910 -1674 9 905 906 907 -1675 10 905 906 915 -1676 11 907 906 915 +1674 9 907 906 905 +1675 10 915 906 905 +1676 11 915 906 907 1677 82 905 910 911 1678 13 905 910 912 1679 13 905 910 913 -1680 83 911 910 912 -1681 83 911 910 913 -1682 15 912 910 913 +1680 83 912 910 911 +1681 83 913 910 911 +1682 15 913 910 912 1683 84 910 911 914 1684 20 906 915 916 1685 21 906 915 919 -1686 22 916 915 919 +1686 22 919 915 916 1687 23 915 916 917 1688 24 915 916 920 1689 25 915 916 921 1690 6 917 916 920 1691 7 917 916 921 1692 8 920 916 921 -1693 9 916 917 918 -1694 10 916 917 927 -1695 11 918 917 927 +1693 9 918 917 916 +1694 10 927 917 916 +1695 11 927 917 918 1696 85 916 921 922 1697 13 916 921 925 1698 13 916 921 926 -1699 60 922 921 925 -1700 60 922 921 926 -1701 15 925 921 926 +1699 60 925 921 922 +1700 60 926 921 922 +1701 15 926 921 925 1702 61 921 922 923 1703 61 921 922 924 -1704 62 923 922 924 +1704 62 924 922 923 1705 20 917 927 928 1706 21 917 927 931 -1707 22 928 927 931 +1707 22 931 927 928 1708 23 927 928 929 1709 24 927 928 932 1710 25 927 928 933 1711 6 929 928 932 1712 7 929 928 933 1713 8 932 928 933 -1714 9 928 929 930 -1715 10 928 929 948 -1716 11 930 929 948 +1714 9 930 929 928 +1715 10 948 929 928 +1716 11 948 929 930 1717 36 928 933 934 1718 13 928 933 941 1719 13 928 933 942 -1720 37 934 933 941 -1721 37 934 933 942 -1722 15 941 933 942 +1720 37 941 933 934 +1721 37 942 933 934 +1722 15 942 933 941 1723 38 933 934 935 1724 38 933 934 936 -1725 39 935 934 936 -1726 39 934 935 937 +1725 39 936 934 935 +1726 39 937 935 934 1727 40 934 935 943 1728 40 937 935 943 -1729 39 934 936 938 +1729 39 938 936 934 1730 40 934 936 944 1731 40 938 936 944 -1732 39 935 937 939 +1732 39 939 937 935 1733 40 935 937 945 1734 40 939 937 945 -1735 39 936 938 939 +1735 39 939 938 936 1736 40 936 938 946 1737 40 939 938 946 -1738 39 937 939 938 +1738 39 938 939 937 1739 94 937 939 940 1740 94 938 939 940 1741 95 939 940 947 1742 20 929 948 949 1743 21 929 948 952 -1744 22 949 948 952 +1744 22 952 948 949 1745 23 948 949 950 1746 24 948 949 953 1747 25 948 949 954 1748 6 950 949 953 1749 7 950 949 954 1750 8 953 949 954 -1751 9 949 950 951 -1752 10 949 950 962 -1753 11 951 950 962 -1754 86 949 954 955 +1751 9 951 950 949 +1752 10 962 950 949 +1753 11 962 950 951 +1754 86 955 954 949 1755 13 949 954 958 1756 13 949 954 959 1757 27 955 954 958 1758 27 955 954 959 -1759 15 958 954 959 -1760 28 954 955 956 -1761 29 954 955 957 -1762 11 956 955 957 +1759 15 959 954 958 +1760 28 956 955 954 +1761 29 957 955 954 +1762 11 957 955 956 1763 21 955 957 960 1764 21 955 957 961 -1765 30 960 957 961 +1765 30 961 957 960 1766 20 950 962 963 1767 21 950 962 966 -1768 22 963 962 966 +1768 22 966 962 963 1769 23 962 963 964 1770 24 962 963 967 1771 31 962 963 968 1772 6 964 963 967 1773 32 964 963 968 1774 33 967 963 968 -1775 9 963 964 965 -1776 10 963 964 981 -1777 11 965 964 981 +1775 9 965 964 963 +1776 10 981 964 963 +1777 11 981 964 965 1778 34 963 968 969 1779 34 963 968 970 -1780 33 963 968 972 -1781 35 969 968 970 -1782 8 969 968 972 -1783 8 970 968 972 +1780 33 972 968 963 +1781 35 970 968 969 +1782 8 972 968 969 +1783 8 972 968 970 1784 12 968 969 971 1785 13 968 969 973 1786 13 968 969 974 1787 14 971 969 973 1788 14 971 969 974 -1789 15 973 969 974 +1789 15 974 969 973 1790 13 968 970 975 1791 13 968 970 976 1792 13 968 970 977 -1793 15 975 970 976 -1794 15 975 970 977 -1795 15 976 970 977 +1793 15 976 970 975 +1794 15 977 970 975 +1795 15 977 970 976 1796 14 969 971 978 1797 14 969 971 979 1798 14 969 971 980 -1799 15 978 971 979 -1800 15 978 971 980 -1801 15 979 971 980 +1799 15 979 971 978 +1800 15 980 971 978 +1801 15 980 971 979 1802 20 964 981 982 1803 21 964 981 985 -1804 22 982 981 985 +1804 22 985 981 982 1805 23 981 982 983 1806 24 981 982 986 1807 25 981 982 987 1808 6 983 982 986 1809 7 983 982 987 1810 8 986 982 987 -1811 9 982 983 984 -1812 10 982 983 998 -1813 11 984 983 998 +1811 9 984 983 982 +1812 10 998 983 982 +1813 11 998 983 984 1814 12 982 987 988 1815 13 982 987 992 1816 13 982 987 993 1817 14 988 987 992 1818 14 988 987 993 -1819 15 992 987 993 -1820 26 987 988 989 +1819 15 993 987 992 +1820 26 989 988 987 1821 14 987 988 994 1822 14 987 988 995 1823 27 989 988 994 1824 27 989 988 995 -1825 15 994 988 995 -1826 28 988 989 990 -1827 29 988 989 991 -1828 11 990 989 991 +1825 15 995 988 994 +1826 28 990 989 988 +1827 29 991 989 988 +1828 11 991 989 990 1829 21 989 991 996 1830 21 989 991 997 -1831 30 996 991 997 +1831 30 997 991 996 1832 20 983 998 999 1833 21 983 998 1002 -1834 22 999 998 1002 +1834 22 1002 998 999 1835 23 998 999 1000 1836 24 998 999 1003 1837 25 998 999 1004 1838 6 1000 999 1003 1839 7 1000 999 1004 1840 8 1003 999 1004 -1841 9 999 1000 1001 -1842 10 999 1000 1020 -1843 11 1001 1000 1020 +1841 9 1001 1000 999 +1842 10 1020 1000 999 +1843 11 1020 1000 1001 1844 12 999 1004 1005 1845 13 999 1004 1009 1846 13 999 1004 1010 1847 14 1005 1004 1009 1848 14 1005 1004 1010 -1849 15 1009 1004 1010 -1850 41 1004 1005 1006 +1849 15 1010 1004 1009 +1850 41 1006 1005 1004 1851 14 1004 1005 1011 1852 14 1004 1005 1012 1853 14 1006 1005 1011 1854 14 1006 1005 1012 -1855 15 1011 1005 1012 -1856 41 1005 1006 1007 +1855 15 1012 1005 1011 +1856 41 1007 1006 1005 1857 14 1005 1006 1013 1858 14 1005 1006 1014 1859 14 1007 1006 1013 1860 14 1007 1006 1014 -1861 15 1013 1006 1014 +1861 15 1014 1006 1013 1862 42 1006 1007 1008 1863 14 1006 1007 1015 1864 14 1006 1007 1016 -1865 43 1008 1007 1015 -1866 43 1008 1007 1016 -1867 15 1015 1007 1016 +1865 43 1015 1007 1008 +1866 43 1016 1007 1008 +1867 15 1016 1007 1015 1868 44 1007 1008 1017 1869 44 1007 1008 1018 1870 44 1007 1008 1019 -1871 45 1017 1008 1018 -1872 45 1017 1008 1019 -1873 45 1018 1008 1019 +1871 45 1018 1008 1017 +1872 45 1019 1008 1017 +1873 45 1019 1008 1018 1874 20 1000 1020 1021 1875 21 1000 1020 1024 -1876 22 1021 1020 1024 +1876 22 1024 1020 1021 1877 23 1020 1021 1022 1878 24 1020 1021 1025 1879 25 1020 1021 1026 1880 6 1022 1021 1025 1881 7 1022 1021 1026 1882 8 1025 1021 1026 -1883 9 1021 1022 1023 -1884 10 1021 1022 1035 -1885 11 1023 1022 1035 +1883 9 1023 1022 1021 +1884 10 1035 1022 1021 +1885 11 1035 1022 1023 1886 12 1021 1026 1027 1887 13 1021 1026 1031 1888 13 1021 1026 1032 1889 14 1027 1026 1031 1890 14 1027 1026 1032 -1891 15 1031 1026 1032 +1891 15 1032 1026 1031 1892 59 1026 1027 1028 1893 14 1026 1027 1033 1894 14 1026 1027 1034 -1895 60 1028 1027 1033 -1896 60 1028 1027 1034 -1897 15 1033 1027 1034 +1895 60 1033 1027 1028 +1896 60 1034 1027 1028 +1897 15 1034 1027 1033 1898 61 1027 1028 1029 1899 61 1027 1028 1030 -1900 62 1029 1028 1030 +1900 62 1030 1028 1029 1901 20 1022 1035 1036 1902 21 1022 1035 1039 -1903 22 1036 1035 1039 +1903 22 1039 1035 1036 1904 23 1035 1036 1037 1905 24 1035 1036 1040 1906 25 1035 1036 1041 1907 6 1037 1036 1040 1908 7 1037 1036 1041 1909 8 1040 1036 1041 -1910 9 1036 1037 1038 -1911 10 1036 1037 1046 -1912 11 1038 1037 1046 +1910 9 1038 1037 1036 +1911 10 1046 1037 1036 +1912 11 1046 1037 1038 1913 82 1036 1041 1042 1914 13 1036 1041 1043 1915 13 1036 1041 1044 -1916 83 1042 1041 1043 -1917 83 1042 1041 1044 -1918 15 1043 1041 1044 +1916 83 1043 1041 1042 +1917 83 1044 1041 1042 +1918 15 1044 1041 1043 1919 84 1041 1042 1045 1920 20 1037 1046 1047 1921 21 1037 1046 1050 -1922 22 1047 1046 1050 +1922 22 1050 1046 1047 1923 23 1046 1047 1048 1924 24 1046 1047 1051 1925 31 1046 1047 1052 1926 6 1048 1047 1051 1927 32 1048 1047 1052 1928 33 1051 1047 1052 -1929 9 1047 1048 1049 -1930 10 1047 1048 1060 -1931 11 1049 1048 1060 +1929 9 1049 1048 1047 +1930 10 1060 1048 1047 +1931 11 1060 1048 1049 1932 46 1047 1052 1053 1933 34 1047 1052 1054 -1934 33 1047 1052 1055 -1935 47 1053 1052 1054 -1936 48 1053 1052 1055 -1937 8 1054 1052 1055 +1934 33 1055 1052 1047 +1935 47 1054 1052 1053 +1936 48 1055 1052 1053 +1937 8 1055 1052 1054 1938 49 1052 1053 1056 1939 13 1052 1054 1057 1940 13 1052 1054 1058 1941 13 1052 1054 1059 -1942 15 1057 1054 1058 -1943 15 1057 1054 1059 -1944 15 1058 1054 1059 +1942 15 1058 1054 1057 +1943 15 1059 1054 1057 +1944 15 1059 1054 1058 1945 20 1048 1060 1061 1946 21 1048 1060 1064 -1947 22 1061 1060 1064 +1947 22 1064 1060 1061 1948 23 1060 1061 1062 1949 24 1060 1061 1065 1950 25 1060 1061 1066 1951 6 1062 1061 1065 1952 7 1062 1061 1066 1953 8 1065 1061 1066 -1954 9 1061 1062 1063 -1955 10 1061 1062 1079 -1956 11 1063 1062 1079 -1957 50 1061 1066 1067 +1954 9 1063 1062 1061 +1955 10 1079 1062 1061 +1956 11 1079 1062 1063 +1957 50 1067 1066 1061 1958 13 1061 1066 1070 1959 13 1061 1066 1071 1960 13 1067 1066 1070 1961 13 1067 1066 1071 -1962 15 1070 1066 1071 -1963 35 1066 1067 1068 -1964 35 1066 1067 1069 -1965 8 1066 1067 1072 -1966 35 1068 1067 1069 -1967 8 1068 1067 1072 -1968 8 1069 1067 1072 +1962 15 1071 1066 1070 +1963 35 1068 1067 1066 +1964 35 1069 1067 1066 +1965 8 1072 1067 1066 +1966 35 1069 1067 1068 +1967 8 1072 1067 1068 +1968 8 1072 1067 1069 1969 13 1067 1068 1073 1970 13 1067 1068 1074 1971 13 1067 1068 1075 -1972 15 1073 1068 1074 -1973 15 1073 1068 1075 -1974 15 1074 1068 1075 +1972 15 1074 1068 1073 +1973 15 1075 1068 1073 +1974 15 1075 1068 1074 1975 13 1067 1069 1076 1976 13 1067 1069 1077 1977 13 1067 1069 1078 -1978 15 1076 1069 1077 -1979 15 1076 1069 1078 -1980 15 1077 1069 1078 +1978 15 1077 1069 1076 +1979 15 1078 1069 1076 +1980 15 1078 1069 1077 1981 20 1062 1079 1080 1982 21 1062 1079 1083 -1983 22 1080 1079 1083 +1983 22 1083 1079 1080 1984 23 1079 1080 1081 1985 24 1079 1080 1084 1986 25 1079 1080 1085 1987 6 1081 1080 1084 1988 7 1081 1080 1085 1989 8 1084 1080 1085 -1990 9 1080 1081 1082 -1991 10 1080 1081 1097 -1992 11 1082 1081 1097 +1990 9 1082 1081 1080 +1991 10 1097 1081 1080 +1992 11 1097 1081 1082 1993 96 1080 1085 1086 1994 13 1080 1085 1091 1995 13 1080 1085 1092 -1996 97 1086 1085 1091 -1997 97 1086 1085 1092 -1998 15 1091 1085 1092 +1996 97 1091 1085 1086 +1997 97 1092 1085 1086 +1998 15 1092 1085 1091 1999 98 1085 1086 1087 2000 99 1085 1086 1088 2001 100 1087 1086 1088 2002 101 1086 1087 1089 -2003 102 1086 1087 1093 -2004 103 1089 1087 1093 -2005 100 1086 1088 1090 +2003 102 1093 1087 1086 +2004 103 1093 1087 1089 +2005 100 1090 1088 1086 2006 104 1086 1088 1094 2007 105 1090 1088 1094 -2008 106 1087 1089 1090 +2008 106 1090 1089 1087 2009 107 1087 1089 1095 2010 107 1090 1089 1095 2011 101 1088 1090 1089 -2012 102 1088 1090 1096 -2013 103 1089 1090 1096 +2012 102 1096 1090 1088 +2013 103 1096 1090 1089 2014 20 1081 1097 1098 2015 21 1081 1097 1101 -2016 22 1098 1097 1101 +2016 22 1101 1097 1098 2017 23 1097 1098 1099 2018 24 1097 1098 1102 2019 25 1097 1098 1103 2020 6 1099 1098 1102 2021 7 1099 1098 1103 2022 8 1102 1098 1103 -2023 9 1098 1099 1100 -2024 10 1098 1099 1116 -2025 11 1100 1099 1116 -2026 50 1098 1103 1104 +2023 9 1100 1099 1098 +2024 10 1116 1099 1098 +2025 11 1116 1099 1100 +2026 50 1104 1103 1098 2027 13 1098 1103 1107 2028 13 1098 1103 1108 2029 13 1104 1103 1107 2030 13 1104 1103 1108 -2031 15 1107 1103 1108 -2032 35 1103 1104 1105 -2033 35 1103 1104 1106 -2034 8 1103 1104 1109 -2035 35 1105 1104 1106 -2036 8 1105 1104 1109 -2037 8 1106 1104 1109 +2031 15 1108 1103 1107 +2032 35 1105 1104 1103 +2033 35 1106 1104 1103 +2034 8 1109 1104 1103 +2035 35 1106 1104 1105 +2036 8 1109 1104 1105 +2037 8 1109 1104 1106 2038 13 1104 1105 1110 2039 13 1104 1105 1111 2040 13 1104 1105 1112 -2041 15 1110 1105 1111 -2042 15 1110 1105 1112 -2043 15 1111 1105 1112 +2041 15 1111 1105 1110 +2042 15 1112 1105 1110 +2043 15 1112 1105 1111 2044 13 1104 1106 1113 2045 13 1104 1106 1114 2046 13 1104 1106 1115 -2047 15 1113 1106 1114 -2048 15 1113 1106 1115 -2049 15 1114 1106 1115 +2047 15 1114 1106 1113 +2048 15 1115 1106 1113 +2049 15 1115 1106 1114 2050 20 1099 1116 1117 2051 21 1099 1116 1120 -2052 22 1117 1116 1120 +2052 22 1120 1116 1117 2053 23 1116 1117 1118 2054 24 1116 1117 1121 2055 31 1116 1117 1122 2056 6 1118 1117 1121 2057 32 1118 1117 1122 2058 33 1121 1117 1122 -2059 9 1117 1118 1119 -2060 10 1117 1118 1132 -2061 11 1119 1118 1132 +2059 9 1119 1118 1117 +2060 10 1132 1118 1117 +2061 11 1132 1118 1119 2062 34 1117 1122 1123 2063 34 1117 1122 1124 -2064 33 1117 1122 1125 -2065 35 1123 1122 1124 -2066 8 1123 1122 1125 -2067 8 1124 1122 1125 +2064 33 1125 1122 1117 +2065 35 1124 1122 1123 +2066 8 1125 1122 1123 +2067 8 1125 1122 1124 2068 13 1122 1123 1126 2069 13 1122 1123 1127 2070 13 1122 1123 1128 -2071 15 1126 1123 1127 -2072 15 1126 1123 1128 -2073 15 1127 1123 1128 +2071 15 1127 1123 1126 +2072 15 1128 1123 1126 +2073 15 1128 1123 1127 2074 13 1122 1124 1129 2075 13 1122 1124 1130 2076 13 1122 1124 1131 -2077 15 1129 1124 1130 -2078 15 1129 1124 1131 -2079 15 1130 1124 1131 +2077 15 1130 1124 1129 +2078 15 1131 1124 1129 +2079 15 1131 1124 1130 2080 20 1118 1132 1133 2081 21 1118 1132 1136 -2082 22 1133 1132 1136 +2082 22 1136 1132 1133 2083 23 1132 1133 1134 2084 24 1132 1133 1137 2085 25 1132 1133 1138 2086 6 1134 1133 1137 2087 7 1134 1133 1138 2088 8 1137 1133 1138 -2089 9 1133 1134 1135 -2090 10 1133 1134 1151 -2091 11 1135 1134 1151 -2092 50 1133 1138 1139 +2089 9 1135 1134 1133 +2090 10 1151 1134 1133 +2091 11 1151 1134 1135 +2092 50 1139 1138 1133 2093 13 1133 1138 1142 2094 13 1133 1138 1143 2095 13 1139 1138 1142 2096 13 1139 1138 1143 -2097 15 1142 1138 1143 -2098 35 1138 1139 1140 -2099 35 1138 1139 1141 -2100 8 1138 1139 1144 -2101 35 1140 1139 1141 -2102 8 1140 1139 1144 -2103 8 1141 1139 1144 +2097 15 1143 1138 1142 +2098 35 1140 1139 1138 +2099 35 1141 1139 1138 +2100 8 1144 1139 1138 +2101 35 1141 1139 1140 +2102 8 1144 1139 1140 +2103 8 1144 1139 1141 2104 13 1139 1140 1145 2105 13 1139 1140 1146 2106 13 1139 1140 1147 -2107 15 1145 1140 1146 -2108 15 1145 1140 1147 -2109 15 1146 1140 1147 +2107 15 1146 1140 1145 +2108 15 1147 1140 1145 +2109 15 1147 1140 1146 2110 13 1139 1141 1148 2111 13 1139 1141 1149 2112 13 1139 1141 1150 -2113 15 1148 1141 1149 -2114 15 1148 1141 1150 -2115 15 1149 1141 1150 +2113 15 1149 1141 1148 +2114 15 1150 1141 1148 +2115 15 1150 1141 1149 2116 20 1134 1151 1152 2117 21 1134 1151 1155 -2118 22 1152 1151 1155 +2118 22 1155 1151 1152 2119 23 1151 1152 1153 2120 24 1151 1152 1156 2121 25 1151 1152 1157 2122 6 1153 1152 1156 2123 7 1153 1152 1157 2124 8 1156 1152 1157 -2125 9 1152 1153 1154 -2126 10 1152 1153 1175 -2127 11 1154 1153 1175 +2125 9 1154 1153 1152 +2126 10 1175 1153 1152 +2127 11 1175 1153 1154 2128 12 1152 1157 1158 2129 13 1152 1157 1164 2130 13 1152 1157 1165 2131 14 1158 1157 1164 2132 14 1158 1157 1165 -2133 15 1164 1157 1165 -2134 41 1157 1158 1159 +2133 15 1165 1157 1164 +2134 41 1159 1158 1157 2135 14 1157 1158 1166 2136 14 1157 1158 1167 2137 14 1159 1158 1166 2138 14 1159 1158 1167 -2139 15 1166 1158 1167 -2140 87 1158 1159 1160 +2139 15 1167 1158 1166 +2140 87 1160 1159 1158 2141 14 1158 1159 1168 2142 14 1158 1159 1169 2143 88 1160 1159 1168 2144 88 1160 1159 1169 -2145 15 1168 1159 1169 +2145 15 1169 1159 1168 2146 89 1159 1160 1161 2147 90 1159 1160 1170 -2148 91 1161 1160 1170 -2149 92 1160 1161 1162 -2150 92 1160 1161 1163 -2151 92 1162 1161 1163 -2152 91 1161 1162 1171 -2153 91 1161 1162 1172 -2154 93 1171 1162 1172 -2155 91 1161 1163 1173 -2156 91 1161 1163 1174 -2157 93 1173 1163 1174 +2148 91 1170 1160 1161 +2149 92 1162 1161 1160 +2150 92 1163 1161 1160 +2151 92 1163 1161 1162 +2152 91 1171 1162 1161 +2153 91 1172 1162 1161 +2154 93 1172 1162 1171 +2155 91 1173 1163 1161 +2156 91 1174 1163 1161 +2157 93 1174 1163 1173 2158 20 1153 1175 1176 2159 21 1153 1175 1179 -2160 22 1176 1175 1179 +2160 22 1179 1175 1176 2161 23 1175 1176 1177 2162 24 1175 1176 1180 2163 25 1175 1176 1181 2164 6 1177 1176 1180 2165 7 1177 1176 1181 2166 8 1180 1176 1181 -2167 9 1176 1177 1178 -2168 10 1176 1177 1194 -2169 11 1178 1177 1194 -2170 50 1176 1181 1182 +2167 9 1178 1177 1176 +2168 10 1194 1177 1176 +2169 11 1194 1177 1178 +2170 50 1182 1181 1176 2171 13 1176 1181 1185 2172 13 1176 1181 1186 2173 13 1182 1181 1185 2174 13 1182 1181 1186 -2175 15 1185 1181 1186 -2176 35 1181 1182 1183 -2177 35 1181 1182 1184 -2178 8 1181 1182 1187 -2179 35 1183 1182 1184 -2180 8 1183 1182 1187 -2181 8 1184 1182 1187 +2175 15 1186 1181 1185 +2176 35 1183 1182 1181 +2177 35 1184 1182 1181 +2178 8 1187 1182 1181 +2179 35 1184 1182 1183 +2180 8 1187 1182 1183 +2181 8 1187 1182 1184 2182 13 1182 1183 1188 2183 13 1182 1183 1189 2184 13 1182 1183 1190 -2185 15 1188 1183 1189 -2186 15 1188 1183 1190 -2187 15 1189 1183 1190 +2185 15 1189 1183 1188 +2186 15 1190 1183 1188 +2187 15 1190 1183 1189 2188 13 1182 1184 1191 2189 13 1182 1184 1192 2190 13 1182 1184 1193 -2191 15 1191 1184 1192 -2192 15 1191 1184 1193 -2193 15 1192 1184 1193 +2191 15 1192 1184 1191 +2192 15 1193 1184 1191 +2193 15 1193 1184 1192 2194 20 1177 1194 1195 2195 21 1177 1194 1198 -2196 22 1195 1194 1198 +2196 22 1198 1194 1195 2197 23 1194 1195 1196 2198 24 1194 1195 1199 2199 25 1194 1195 1200 2200 6 1196 1195 1199 2201 7 1196 1195 1200 2202 8 1199 1195 1200 -2203 9 1195 1196 1197 -2204 10 1195 1196 1218 -2205 11 1197 1196 1218 +2203 9 1197 1196 1195 +2204 10 1218 1196 1195 +2205 11 1218 1196 1197 2206 12 1195 1200 1201 2207 13 1195 1200 1207 2208 13 1195 1200 1208 2209 14 1201 1200 1207 2210 14 1201 1200 1208 -2211 15 1207 1200 1208 -2212 41 1200 1201 1202 +2211 15 1208 1200 1207 +2212 41 1202 1201 1200 2213 14 1200 1201 1209 2214 14 1200 1201 1210 2215 14 1202 1201 1209 2216 14 1202 1201 1210 -2217 15 1209 1201 1210 -2218 87 1201 1202 1203 +2217 15 1210 1201 1209 +2218 87 1203 1202 1201 2219 14 1201 1202 1211 2220 14 1201 1202 1212 2221 88 1203 1202 1211 2222 88 1203 1202 1212 -2223 15 1211 1202 1212 +2223 15 1212 1202 1211 2224 89 1202 1203 1204 2225 90 1202 1203 1213 -2226 91 1204 1203 1213 -2227 92 1203 1204 1205 -2228 92 1203 1204 1206 -2229 92 1205 1204 1206 -2230 91 1204 1205 1214 -2231 91 1204 1205 1215 -2232 93 1214 1205 1215 -2233 91 1204 1206 1216 -2234 91 1204 1206 1217 -2235 93 1216 1206 1217 -2236 51 1196 1218 1219 +2226 91 1213 1203 1204 +2227 92 1205 1204 1203 +2228 92 1206 1204 1203 +2229 92 1206 1204 1205 +2230 91 1214 1205 1204 +2231 91 1215 1205 1204 +2232 93 1215 1205 1214 +2233 91 1216 1206 1204 +2234 91 1217 1206 1204 +2235 93 1217 1206 1216 +2236 51 1219 1218 1196 2237 21 1196 1218 1222 2238 52 1219 1218 1222 2239 53 1218 1219 1220 @@ -18917,2857 +18919,2857 @@ Angles 2241 54 1218 1219 1224 2242 55 1220 1219 1223 2243 55 1220 1219 1224 -2244 56 1223 1219 1224 +2244 56 1224 1219 1223 2245 57 1219 1220 1221 -2246 58 1219 1220 1225 -2247 11 1221 1220 1225 -2248 51 1220 1225 1226 +2246 58 1225 1220 1219 +2247 11 1225 1220 1221 +2248 51 1226 1225 1220 2249 21 1220 1225 1229 2250 52 1226 1225 1229 2251 108 1225 1226 1227 2252 54 1225 1226 1230 2253 54 1225 1226 1231 -2254 109 1227 1226 1230 -2255 109 1227 1226 1231 -2256 56 1230 1226 1231 +2254 109 1230 1226 1227 +2255 109 1231 1226 1227 +2256 56 1231 1226 1230 2257 110 1226 1227 1228 2258 110 1226 1227 1232 -2259 62 1228 1227 1232 -2260 111 1234 1233 1235 -2261 111 1237 1236 1238 -2262 111 1240 1239 1241 -2263 111 1243 1242 1244 -2264 111 1246 1245 1247 -2265 111 1249 1248 1250 -2266 111 1252 1251 1253 -2267 111 1255 1254 1256 -2268 111 1258 1257 1259 -2269 111 1261 1260 1262 -2270 111 1264 1263 1265 -2271 111 1267 1266 1268 -2272 111 1270 1269 1271 -2273 111 1273 1272 1274 -2274 111 1276 1275 1277 -2275 111 1279 1278 1280 -2276 111 1282 1281 1283 -2277 111 1285 1284 1286 -2278 111 1288 1287 1289 -2279 111 1291 1290 1292 -2280 111 1294 1293 1295 -2281 111 1297 1296 1298 -2282 111 1300 1299 1301 -2283 111 1303 1302 1304 -2284 111 1306 1305 1307 -2285 111 1309 1308 1310 -2286 111 1312 1311 1313 -2287 111 1315 1314 1316 -2288 111 1318 1317 1319 -2289 111 1321 1320 1322 -2290 111 1324 1323 1325 -2291 111 1327 1326 1328 -2292 111 1330 1329 1331 -2293 111 1333 1332 1334 -2294 111 1336 1335 1337 -2295 111 1339 1338 1340 -2296 111 1342 1341 1343 -2297 111 1345 1344 1346 -2298 111 1348 1347 1349 -2299 111 1351 1350 1352 -2300 111 1354 1353 1355 -2301 111 1357 1356 1358 -2302 111 1360 1359 1361 -2303 111 1363 1362 1364 -2304 111 1366 1365 1367 -2305 111 1369 1368 1370 -2306 111 1372 1371 1373 -2307 111 1375 1374 1376 -2308 111 1378 1377 1379 -2309 111 1381 1380 1382 -2310 111 1384 1383 1385 -2311 111 1387 1386 1388 -2312 111 1390 1389 1391 -2313 111 1393 1392 1394 -2314 111 1396 1395 1397 -2315 111 1399 1398 1400 -2316 111 1402 1401 1403 -2317 111 1405 1404 1406 -2318 111 1408 1407 1409 -2319 111 1411 1410 1412 -2320 111 1414 1413 1415 -2321 111 1417 1416 1418 -2322 111 1420 1419 1421 -2323 111 1423 1422 1424 -2324 111 1426 1425 1427 -2325 111 1429 1428 1430 -2326 111 1432 1431 1433 -2327 111 1435 1434 1436 -2328 111 1438 1437 1439 -2329 111 1441 1440 1442 -2330 111 1444 1443 1445 -2331 111 1447 1446 1448 -2332 111 1450 1449 1451 -2333 111 1453 1452 1454 -2334 111 1456 1455 1457 -2335 111 1459 1458 1460 -2336 111 1462 1461 1463 -2337 111 1465 1464 1466 -2338 111 1468 1467 1469 -2339 111 1471 1470 1472 -2340 111 1474 1473 1475 -2341 111 1477 1476 1478 -2342 111 1480 1479 1481 -2343 111 1483 1482 1484 -2344 111 1486 1485 1487 -2345 111 1489 1488 1490 -2346 111 1492 1491 1493 -2347 111 1495 1494 1496 -2348 111 1498 1497 1499 -2349 111 1501 1500 1502 -2350 111 1504 1503 1505 -2351 111 1507 1506 1508 -2352 111 1510 1509 1511 -2353 111 1513 1512 1514 -2354 111 1516 1515 1517 -2355 111 1519 1518 1520 -2356 111 1522 1521 1523 -2357 111 1525 1524 1526 -2358 111 1528 1527 1529 -2359 111 1531 1530 1532 -2360 111 1534 1533 1535 -2361 111 1537 1536 1538 -2362 111 1540 1539 1541 -2363 111 1543 1542 1544 -2364 111 1546 1545 1547 -2365 111 1549 1548 1550 -2366 111 1552 1551 1553 -2367 111 1555 1554 1556 -2368 111 1558 1557 1559 -2369 111 1561 1560 1562 -2370 111 1564 1563 1565 -2371 111 1567 1566 1568 -2372 111 1570 1569 1571 -2373 111 1573 1572 1574 -2374 111 1576 1575 1577 -2375 111 1579 1578 1580 -2376 111 1582 1581 1583 -2377 111 1585 1584 1586 -2378 111 1588 1587 1589 -2379 111 1591 1590 1592 -2380 111 1594 1593 1595 -2381 111 1597 1596 1598 -2382 111 1600 1599 1601 -2383 111 1603 1602 1604 -2384 111 1606 1605 1607 -2385 111 1609 1608 1610 -2386 111 1612 1611 1613 -2387 111 1615 1614 1616 -2388 111 1618 1617 1619 -2389 111 1621 1620 1622 -2390 111 1624 1623 1625 -2391 111 1627 1626 1628 -2392 111 1630 1629 1631 -2393 111 1633 1632 1634 -2394 111 1636 1635 1637 -2395 111 1639 1638 1640 -2396 111 1642 1641 1643 -2397 111 1645 1644 1646 -2398 111 1648 1647 1649 -2399 111 1651 1650 1652 -2400 111 1654 1653 1655 -2401 111 1657 1656 1658 -2402 111 1660 1659 1661 -2403 111 1663 1662 1664 -2404 111 1666 1665 1667 -2405 111 1669 1668 1670 -2406 111 1672 1671 1673 -2407 111 1675 1674 1676 -2408 111 1678 1677 1679 -2409 111 1681 1680 1682 -2410 111 1684 1683 1685 -2411 111 1687 1686 1688 -2412 111 1690 1689 1691 -2413 111 1693 1692 1694 -2414 111 1696 1695 1697 -2415 111 1699 1698 1700 -2416 111 1702 1701 1703 -2417 111 1705 1704 1706 -2418 111 1708 1707 1709 -2419 111 1711 1710 1712 -2420 111 1714 1713 1715 -2421 111 1717 1716 1718 -2422 111 1720 1719 1721 -2423 111 1723 1722 1724 -2424 111 1726 1725 1727 -2425 111 1729 1728 1730 -2426 111 1732 1731 1733 -2427 111 1735 1734 1736 -2428 111 1738 1737 1739 -2429 111 1741 1740 1742 -2430 111 1744 1743 1745 -2431 111 1747 1746 1748 -2432 111 1750 1749 1751 -2433 111 1753 1752 1754 -2434 111 1756 1755 1757 -2435 111 1759 1758 1760 -2436 111 1762 1761 1763 -2437 111 1765 1764 1766 -2438 111 1768 1767 1769 -2439 111 1771 1770 1772 -2440 111 1774 1773 1775 -2441 111 1777 1776 1778 -2442 111 1780 1779 1781 -2443 111 1783 1782 1784 -2444 111 1786 1785 1787 -2445 111 1789 1788 1790 -2446 111 1792 1791 1793 -2447 111 1795 1794 1796 -2448 111 1798 1797 1799 -2449 111 1801 1800 1802 -2450 111 1804 1803 1805 -2451 111 1807 1806 1808 -2452 111 1810 1809 1811 -2453 111 1813 1812 1814 -2454 111 1816 1815 1817 -2455 111 1819 1818 1820 -2456 111 1822 1821 1823 -2457 111 1825 1824 1826 -2458 111 1828 1827 1829 -2459 111 1831 1830 1832 -2460 111 1834 1833 1835 -2461 111 1837 1836 1838 -2462 111 1840 1839 1841 -2463 111 1843 1842 1844 -2464 111 1846 1845 1847 -2465 111 1849 1848 1850 -2466 111 1852 1851 1853 -2467 111 1855 1854 1856 -2468 111 1858 1857 1859 -2469 111 1861 1860 1862 -2470 111 1864 1863 1865 -2471 111 1867 1866 1868 -2472 111 1870 1869 1871 -2473 111 1873 1872 1874 -2474 111 1876 1875 1877 -2475 111 1879 1878 1880 -2476 111 1882 1881 1883 -2477 111 1885 1884 1886 -2478 111 1888 1887 1889 -2479 111 1891 1890 1892 -2480 111 1894 1893 1895 -2481 111 1897 1896 1898 -2482 111 1900 1899 1901 -2483 111 1903 1902 1904 -2484 111 1906 1905 1907 -2485 111 1909 1908 1910 -2486 111 1912 1911 1913 -2487 111 1915 1914 1916 -2488 111 1918 1917 1919 -2489 111 1921 1920 1922 -2490 111 1924 1923 1925 -2491 111 1927 1926 1928 -2492 111 1930 1929 1931 -2493 111 1933 1932 1934 -2494 111 1936 1935 1937 -2495 111 1939 1938 1940 -2496 111 1942 1941 1943 -2497 111 1945 1944 1946 -2498 111 1948 1947 1949 -2499 111 1951 1950 1952 -2500 111 1954 1953 1955 -2501 111 1957 1956 1958 -2502 111 1960 1959 1961 -2503 111 1963 1962 1964 -2504 111 1966 1965 1967 -2505 111 1969 1968 1970 -2506 111 1972 1971 1973 -2507 111 1975 1974 1976 -2508 111 1978 1977 1979 -2509 111 1981 1980 1982 -2510 111 1984 1983 1985 -2511 111 1987 1986 1988 -2512 111 1990 1989 1991 -2513 111 1993 1992 1994 -2514 111 1996 1995 1997 -2515 111 1999 1998 2000 -2516 111 2002 2001 2003 -2517 111 2005 2004 2006 -2518 111 2008 2007 2009 -2519 111 2011 2010 2012 -2520 111 2014 2013 2015 -2521 111 2017 2016 2018 -2522 111 2020 2019 2021 -2523 111 2023 2022 2024 -2524 111 2026 2025 2027 -2525 111 2029 2028 2030 -2526 111 2032 2031 2033 -2527 111 2035 2034 2036 -2528 111 2038 2037 2039 -2529 111 2041 2040 2042 -2530 111 2044 2043 2045 -2531 111 2047 2046 2048 -2532 111 2050 2049 2051 -2533 111 2053 2052 2054 -2534 111 2056 2055 2057 -2535 111 2059 2058 2060 -2536 111 2062 2061 2063 -2537 111 2065 2064 2066 -2538 111 2068 2067 2069 -2539 111 2071 2070 2072 -2540 111 2074 2073 2075 -2541 111 2077 2076 2078 -2542 111 2080 2079 2081 -2543 111 2083 2082 2084 -2544 111 2086 2085 2087 -2545 111 2089 2088 2090 -2546 111 2092 2091 2093 -2547 111 2095 2094 2096 -2548 111 2098 2097 2099 -2549 111 2101 2100 2102 -2550 111 2104 2103 2105 -2551 111 2107 2106 2108 -2552 111 2110 2109 2111 -2553 111 2113 2112 2114 -2554 111 2116 2115 2117 -2555 111 2119 2118 2120 -2556 111 2122 2121 2123 -2557 111 2125 2124 2126 -2558 111 2128 2127 2129 -2559 111 2131 2130 2132 -2560 111 2134 2133 2135 -2561 111 2137 2136 2138 -2562 111 2140 2139 2141 -2563 111 2143 2142 2144 -2564 111 2146 2145 2147 -2565 111 2149 2148 2150 -2566 111 2152 2151 2153 -2567 111 2155 2154 2156 -2568 111 2158 2157 2159 -2569 111 2161 2160 2162 -2570 111 2164 2163 2165 -2571 111 2167 2166 2168 -2572 111 2170 2169 2171 -2573 111 2173 2172 2174 -2574 111 2176 2175 2177 -2575 111 2179 2178 2180 -2576 111 2182 2181 2183 -2577 111 2185 2184 2186 -2578 111 2188 2187 2189 -2579 111 2191 2190 2192 -2580 111 2194 2193 2195 -2581 111 2197 2196 2198 -2582 111 2200 2199 2201 -2583 111 2203 2202 2204 -2584 111 2206 2205 2207 -2585 111 2209 2208 2210 -2586 111 2212 2211 2213 -2587 111 2215 2214 2216 -2588 111 2218 2217 2219 -2589 111 2221 2220 2222 -2590 111 2224 2223 2225 -2591 111 2227 2226 2228 -2592 111 2230 2229 2231 -2593 111 2233 2232 2234 -2594 111 2236 2235 2237 -2595 111 2239 2238 2240 -2596 111 2242 2241 2243 -2597 111 2245 2244 2246 -2598 111 2248 2247 2249 -2599 111 2251 2250 2252 -2600 111 2254 2253 2255 -2601 111 2257 2256 2258 -2602 111 2260 2259 2261 -2603 111 2263 2262 2264 -2604 111 2266 2265 2267 -2605 111 2269 2268 2270 -2606 111 2272 2271 2273 -2607 111 2275 2274 2276 -2608 111 2278 2277 2279 -2609 111 2281 2280 2282 -2610 111 2284 2283 2285 -2611 111 2287 2286 2288 -2612 111 2290 2289 2291 -2613 111 2293 2292 2294 -2614 111 2296 2295 2297 -2615 111 2299 2298 2300 -2616 111 2302 2301 2303 -2617 111 2305 2304 2306 -2618 111 2308 2307 2309 -2619 111 2311 2310 2312 -2620 111 2314 2313 2315 -2621 111 2317 2316 2318 -2622 111 2320 2319 2321 -2623 111 2323 2322 2324 -2624 111 2326 2325 2327 -2625 111 2329 2328 2330 -2626 111 2332 2331 2333 -2627 111 2335 2334 2336 -2628 111 2338 2337 2339 -2629 111 2341 2340 2342 -2630 111 2344 2343 2345 -2631 111 2347 2346 2348 -2632 111 2350 2349 2351 -2633 111 2353 2352 2354 -2634 111 2356 2355 2357 -2635 111 2359 2358 2360 -2636 111 2362 2361 2363 -2637 111 2365 2364 2366 -2638 111 2368 2367 2369 -2639 111 2371 2370 2372 -2640 111 2374 2373 2375 -2641 111 2377 2376 2378 -2642 111 2380 2379 2381 -2643 111 2383 2382 2384 -2644 111 2386 2385 2387 -2645 111 2389 2388 2390 -2646 111 2392 2391 2393 -2647 111 2395 2394 2396 -2648 111 2398 2397 2399 -2649 111 2401 2400 2402 -2650 111 2404 2403 2405 -2651 111 2407 2406 2408 -2652 111 2410 2409 2411 -2653 111 2413 2412 2414 -2654 111 2416 2415 2417 -2655 111 2419 2418 2420 -2656 111 2422 2421 2423 -2657 111 2425 2424 2426 -2658 111 2428 2427 2429 -2659 111 2431 2430 2432 -2660 111 2434 2433 2435 -2661 111 2437 2436 2438 -2662 111 2440 2439 2441 -2663 111 2443 2442 2444 -2664 111 2446 2445 2447 -2665 111 2449 2448 2450 -2666 111 2452 2451 2453 -2667 111 2455 2454 2456 -2668 111 2458 2457 2459 -2669 111 2461 2460 2462 -2670 111 2464 2463 2465 -2671 111 2467 2466 2468 -2672 111 2470 2469 2471 -2673 111 2473 2472 2474 -2674 111 2476 2475 2477 -2675 111 2479 2478 2480 -2676 111 2482 2481 2483 -2677 111 2485 2484 2486 -2678 111 2488 2487 2489 -2679 111 2491 2490 2492 -2680 111 2494 2493 2495 -2681 111 2497 2496 2498 -2682 111 2500 2499 2501 -2683 111 2503 2502 2504 -2684 111 2506 2505 2507 -2685 111 2509 2508 2510 -2686 111 2512 2511 2513 -2687 111 2515 2514 2516 -2688 111 2518 2517 2519 -2689 111 2521 2520 2522 -2690 111 2524 2523 2525 -2691 111 2527 2526 2528 -2692 111 2530 2529 2531 -2693 111 2533 2532 2534 -2694 111 2536 2535 2537 -2695 111 2539 2538 2540 -2696 111 2542 2541 2543 -2697 111 2545 2544 2546 -2698 111 2548 2547 2549 -2699 111 2551 2550 2552 -2700 111 2554 2553 2555 -2701 111 2557 2556 2558 -2702 111 2560 2559 2561 -2703 111 2563 2562 2564 -2704 111 2566 2565 2567 -2705 111 2569 2568 2570 -2706 111 2572 2571 2573 -2707 111 2575 2574 2576 -2708 111 2578 2577 2579 -2709 111 2581 2580 2582 -2710 111 2584 2583 2585 -2711 111 2587 2586 2588 -2712 111 2590 2589 2591 -2713 111 2593 2592 2594 -2714 111 2596 2595 2597 -2715 111 2599 2598 2600 -2716 111 2602 2601 2603 -2717 111 2605 2604 2606 -2718 111 2608 2607 2609 -2719 111 2611 2610 2612 -2720 111 2614 2613 2615 -2721 111 2617 2616 2618 -2722 111 2620 2619 2621 -2723 111 2623 2622 2624 -2724 111 2626 2625 2627 -2725 111 2629 2628 2630 -2726 111 2632 2631 2633 -2727 111 2635 2634 2636 -2728 111 2638 2637 2639 -2729 111 2641 2640 2642 -2730 111 2644 2643 2645 -2731 111 2647 2646 2648 -2732 111 2650 2649 2651 -2733 111 2653 2652 2654 -2734 111 2656 2655 2657 -2735 111 2659 2658 2660 -2736 111 2662 2661 2663 -2737 111 2665 2664 2666 -2738 111 2668 2667 2669 -2739 111 2671 2670 2672 -2740 111 2674 2673 2675 -2741 111 2677 2676 2678 -2742 111 2680 2679 2681 -2743 111 2683 2682 2684 -2744 111 2686 2685 2687 -2745 111 2689 2688 2690 -2746 111 2692 2691 2693 -2747 111 2695 2694 2696 -2748 111 2698 2697 2699 -2749 111 2701 2700 2702 -2750 111 2704 2703 2705 -2751 111 2707 2706 2708 -2752 111 2710 2709 2711 -2753 111 2713 2712 2714 -2754 111 2716 2715 2717 -2755 111 2719 2718 2720 -2756 111 2722 2721 2723 -2757 111 2725 2724 2726 -2758 111 2728 2727 2729 -2759 111 2731 2730 2732 -2760 111 2734 2733 2735 -2761 111 2737 2736 2738 -2762 111 2740 2739 2741 -2763 111 2743 2742 2744 -2764 111 2746 2745 2747 -2765 111 2749 2748 2750 -2766 111 2752 2751 2753 -2767 111 2755 2754 2756 -2768 111 2758 2757 2759 -2769 111 2761 2760 2762 -2770 111 2764 2763 2765 -2771 111 2767 2766 2768 -2772 111 2770 2769 2771 -2773 111 2773 2772 2774 -2774 111 2776 2775 2777 -2775 111 2779 2778 2780 -2776 111 2782 2781 2783 -2777 111 2785 2784 2786 -2778 111 2788 2787 2789 -2779 111 2791 2790 2792 -2780 111 2794 2793 2795 -2781 111 2797 2796 2798 -2782 111 2800 2799 2801 -2783 111 2803 2802 2804 -2784 111 2806 2805 2807 -2785 111 2809 2808 2810 -2786 111 2812 2811 2813 -2787 111 2815 2814 2816 -2788 111 2818 2817 2819 -2789 111 2821 2820 2822 -2790 111 2824 2823 2825 -2791 111 2827 2826 2828 -2792 111 2830 2829 2831 -2793 111 2833 2832 2834 -2794 111 2836 2835 2837 -2795 111 2839 2838 2840 -2796 111 2842 2841 2843 -2797 111 2845 2844 2846 -2798 111 2848 2847 2849 -2799 111 2851 2850 2852 -2800 111 2854 2853 2855 -2801 111 2857 2856 2858 -2802 111 2860 2859 2861 -2803 111 2863 2862 2864 -2804 111 2866 2865 2867 -2805 111 2869 2868 2870 -2806 111 2872 2871 2873 -2807 111 2875 2874 2876 -2808 111 2878 2877 2879 -2809 111 2881 2880 2882 -2810 111 2884 2883 2885 -2811 111 2887 2886 2888 -2812 111 2890 2889 2891 -2813 111 2893 2892 2894 -2814 111 2896 2895 2897 -2815 111 2899 2898 2900 -2816 111 2902 2901 2903 -2817 111 2905 2904 2906 -2818 111 2908 2907 2909 -2819 111 2911 2910 2912 -2820 111 2914 2913 2915 -2821 111 2917 2916 2918 -2822 111 2920 2919 2921 -2823 111 2923 2922 2924 -2824 111 2926 2925 2927 -2825 111 2929 2928 2930 -2826 111 2932 2931 2933 -2827 111 2935 2934 2936 -2828 111 2938 2937 2939 -2829 111 2941 2940 2942 -2830 111 2944 2943 2945 -2831 111 2947 2946 2948 -2832 111 2950 2949 2951 -2833 111 2953 2952 2954 -2834 111 2956 2955 2957 -2835 111 2959 2958 2960 -2836 111 2962 2961 2963 -2837 111 2965 2964 2966 -2838 111 2968 2967 2969 -2839 111 2971 2970 2972 -2840 111 2974 2973 2975 -2841 111 2977 2976 2978 -2842 111 2980 2979 2981 -2843 111 2983 2982 2984 -2844 111 2986 2985 2987 -2845 111 2989 2988 2990 -2846 111 2992 2991 2993 -2847 111 2995 2994 2996 -2848 111 2998 2997 2999 -2849 111 3001 3000 3002 -2850 111 3004 3003 3005 -2851 111 3007 3006 3008 -2852 111 3010 3009 3011 -2853 111 3013 3012 3014 -2854 111 3016 3015 3017 -2855 111 3019 3018 3020 -2856 111 3022 3021 3023 -2857 111 3025 3024 3026 -2858 111 3028 3027 3029 -2859 111 3031 3030 3032 -2860 111 3034 3033 3035 -2861 111 3037 3036 3038 -2862 111 3040 3039 3041 -2863 111 3043 3042 3044 -2864 111 3046 3045 3047 -2865 111 3049 3048 3050 -2866 111 3052 3051 3053 -2867 111 3055 3054 3056 -2868 111 3058 3057 3059 -2869 111 3061 3060 3062 -2870 111 3064 3063 3065 -2871 111 3067 3066 3068 -2872 111 3070 3069 3071 -2873 111 3073 3072 3074 -2874 111 3076 3075 3077 -2875 111 3079 3078 3080 -2876 111 3082 3081 3083 -2877 111 3085 3084 3086 -2878 111 3088 3087 3089 -2879 111 3091 3090 3092 -2880 111 3094 3093 3095 -2881 111 3097 3096 3098 -2882 111 3100 3099 3101 -2883 111 3103 3102 3104 -2884 111 3106 3105 3107 -2885 111 3109 3108 3110 -2886 111 3112 3111 3113 -2887 111 3115 3114 3116 -2888 111 3118 3117 3119 -2889 111 3121 3120 3122 -2890 111 3124 3123 3125 -2891 111 3127 3126 3128 -2892 111 3130 3129 3131 -2893 111 3133 3132 3134 -2894 111 3136 3135 3137 -2895 111 3139 3138 3140 -2896 111 3142 3141 3143 -2897 111 3145 3144 3146 -2898 111 3148 3147 3149 -2899 111 3151 3150 3152 -2900 111 3154 3153 3155 -2901 111 3157 3156 3158 -2902 111 3160 3159 3161 -2903 111 3163 3162 3164 -2904 111 3166 3165 3167 -2905 111 3169 3168 3170 -2906 111 3172 3171 3173 -2907 111 3175 3174 3176 -2908 111 3178 3177 3179 -2909 111 3181 3180 3182 -2910 111 3184 3183 3185 -2911 111 3187 3186 3188 -2912 111 3190 3189 3191 -2913 111 3193 3192 3194 -2914 111 3196 3195 3197 -2915 111 3199 3198 3200 -2916 111 3202 3201 3203 -2917 111 3205 3204 3206 -2918 111 3208 3207 3209 -2919 111 3211 3210 3212 -2920 111 3214 3213 3215 -2921 111 3217 3216 3218 -2922 111 3220 3219 3221 -2923 111 3223 3222 3224 -2924 111 3226 3225 3227 -2925 111 3229 3228 3230 -2926 111 3232 3231 3233 -2927 111 3235 3234 3236 -2928 111 3238 3237 3239 -2929 111 3241 3240 3242 -2930 111 3244 3243 3245 -2931 111 3247 3246 3248 -2932 111 3250 3249 3251 -2933 111 3253 3252 3254 -2934 111 3256 3255 3257 -2935 111 3259 3258 3260 -2936 111 3262 3261 3263 -2937 111 3265 3264 3266 -2938 111 3268 3267 3269 -2939 111 3271 3270 3272 -2940 111 3274 3273 3275 -2941 111 3277 3276 3278 -2942 111 3280 3279 3281 -2943 111 3283 3282 3284 -2944 111 3286 3285 3287 -2945 111 3289 3288 3290 -2946 111 3292 3291 3293 -2947 111 3295 3294 3296 -2948 111 3298 3297 3299 -2949 111 3301 3300 3302 -2950 111 3304 3303 3305 -2951 111 3307 3306 3308 -2952 111 3310 3309 3311 -2953 111 3313 3312 3314 -2954 111 3316 3315 3317 -2955 111 3319 3318 3320 -2956 111 3322 3321 3323 -2957 111 3325 3324 3326 -2958 111 3328 3327 3329 -2959 111 3331 3330 3332 -2960 111 3334 3333 3335 -2961 111 3337 3336 3338 -2962 111 3340 3339 3341 -2963 111 3343 3342 3344 -2964 111 3346 3345 3347 -2965 111 3349 3348 3350 -2966 111 3352 3351 3353 -2967 111 3355 3354 3356 -2968 111 3358 3357 3359 -2969 111 3361 3360 3362 -2970 111 3364 3363 3365 -2971 111 3367 3366 3368 -2972 111 3370 3369 3371 -2973 111 3373 3372 3374 -2974 111 3376 3375 3377 -2975 111 3379 3378 3380 -2976 111 3382 3381 3383 -2977 111 3385 3384 3386 -2978 111 3388 3387 3389 -2979 111 3391 3390 3392 -2980 111 3394 3393 3395 -2981 111 3397 3396 3398 -2982 111 3400 3399 3401 -2983 111 3403 3402 3404 -2984 111 3406 3405 3407 -2985 111 3409 3408 3410 -2986 111 3412 3411 3413 -2987 111 3415 3414 3416 -2988 111 3418 3417 3419 -2989 111 3421 3420 3422 -2990 111 3424 3423 3425 -2991 111 3427 3426 3428 -2992 111 3430 3429 3431 -2993 111 3433 3432 3434 -2994 111 3436 3435 3437 -2995 111 3439 3438 3440 -2996 111 3442 3441 3443 -2997 111 3445 3444 3446 -2998 111 3448 3447 3449 -2999 111 3451 3450 3452 -3000 111 3454 3453 3455 -3001 111 3457 3456 3458 -3002 111 3460 3459 3461 -3003 111 3463 3462 3464 -3004 111 3466 3465 3467 -3005 111 3469 3468 3470 -3006 111 3472 3471 3473 -3007 111 3475 3474 3476 -3008 111 3478 3477 3479 -3009 111 3481 3480 3482 -3010 111 3484 3483 3485 -3011 111 3487 3486 3488 -3012 111 3490 3489 3491 -3013 111 3493 3492 3494 -3014 111 3496 3495 3497 -3015 111 3499 3498 3500 -3016 111 3502 3501 3503 -3017 111 3505 3504 3506 -3018 111 3508 3507 3509 -3019 111 3511 3510 3512 -3020 111 3514 3513 3515 -3021 111 3517 3516 3518 -3022 111 3520 3519 3521 -3023 111 3523 3522 3524 -3024 111 3526 3525 3527 -3025 111 3529 3528 3530 -3026 111 3532 3531 3533 -3027 111 3535 3534 3536 -3028 111 3538 3537 3539 -3029 111 3541 3540 3542 -3030 111 3544 3543 3545 -3031 111 3547 3546 3548 -3032 111 3550 3549 3551 -3033 111 3553 3552 3554 -3034 111 3556 3555 3557 -3035 111 3559 3558 3560 -3036 111 3562 3561 3563 -3037 111 3565 3564 3566 -3038 111 3568 3567 3569 -3039 111 3571 3570 3572 -3040 111 3574 3573 3575 -3041 111 3577 3576 3578 -3042 111 3580 3579 3581 -3043 111 3583 3582 3584 -3044 111 3586 3585 3587 -3045 111 3589 3588 3590 -3046 111 3592 3591 3593 -3047 111 3595 3594 3596 -3048 111 3598 3597 3599 -3049 111 3601 3600 3602 -3050 111 3604 3603 3605 -3051 111 3607 3606 3608 -3052 111 3610 3609 3611 -3053 111 3613 3612 3614 -3054 111 3616 3615 3617 -3055 111 3619 3618 3620 -3056 111 3622 3621 3623 -3057 111 3625 3624 3626 -3058 111 3628 3627 3629 -3059 111 3631 3630 3632 -3060 111 3634 3633 3635 -3061 111 3637 3636 3638 -3062 111 3640 3639 3641 -3063 111 3643 3642 3644 -3064 111 3646 3645 3647 -3065 111 3649 3648 3650 -3066 111 3652 3651 3653 -3067 111 3655 3654 3656 -3068 111 3658 3657 3659 -3069 111 3661 3660 3662 -3070 111 3664 3663 3665 -3071 111 3667 3666 3668 -3072 111 3670 3669 3671 -3073 111 3673 3672 3674 -3074 111 3676 3675 3677 -3075 111 3679 3678 3680 -3076 111 3682 3681 3683 -3077 111 3685 3684 3686 -3078 111 3688 3687 3689 -3079 111 3691 3690 3692 -3080 111 3694 3693 3695 -3081 111 3697 3696 3698 -3082 111 3700 3699 3701 -3083 111 3703 3702 3704 -3084 111 3706 3705 3707 -3085 111 3709 3708 3710 -3086 111 3712 3711 3713 -3087 111 3715 3714 3716 -3088 111 3718 3717 3719 -3089 111 3721 3720 3722 -3090 111 3724 3723 3725 -3091 111 3727 3726 3728 -3092 111 3730 3729 3731 -3093 111 3733 3732 3734 -3094 111 3736 3735 3737 -3095 111 3739 3738 3740 -3096 111 3742 3741 3743 -3097 111 3745 3744 3746 -3098 111 3748 3747 3749 -3099 111 3751 3750 3752 -3100 111 3754 3753 3755 -3101 111 3757 3756 3758 -3102 111 3760 3759 3761 -3103 111 3763 3762 3764 -3104 111 3766 3765 3767 -3105 111 3769 3768 3770 -3106 111 3772 3771 3773 -3107 111 3775 3774 3776 -3108 111 3778 3777 3779 -3109 111 3781 3780 3782 -3110 111 3784 3783 3785 -3111 111 3787 3786 3788 -3112 111 3790 3789 3791 -3113 111 3793 3792 3794 -3114 111 3796 3795 3797 -3115 111 3799 3798 3800 -3116 111 3802 3801 3803 -3117 111 3805 3804 3806 -3118 111 3808 3807 3809 -3119 111 3811 3810 3812 -3120 111 3814 3813 3815 -3121 111 3817 3816 3818 -3122 111 3820 3819 3821 -3123 111 3823 3822 3824 -3124 111 3826 3825 3827 -3125 111 3829 3828 3830 -3126 111 3832 3831 3833 -3127 111 3835 3834 3836 -3128 111 3838 3837 3839 -3129 111 3841 3840 3842 -3130 111 3844 3843 3845 -3131 111 3847 3846 3848 -3132 111 3850 3849 3851 -3133 111 3853 3852 3854 -3134 111 3856 3855 3857 -3135 111 3859 3858 3860 -3136 111 3862 3861 3863 -3137 111 3865 3864 3866 -3138 111 3868 3867 3869 -3139 111 3871 3870 3872 -3140 111 3874 3873 3875 -3141 111 3877 3876 3878 -3142 111 3880 3879 3881 -3143 111 3883 3882 3884 -3144 111 3886 3885 3887 -3145 111 3889 3888 3890 -3146 111 3892 3891 3893 -3147 111 3895 3894 3896 -3148 111 3898 3897 3899 -3149 111 3901 3900 3902 -3150 111 3904 3903 3905 -3151 111 3907 3906 3908 -3152 111 3910 3909 3911 -3153 111 3913 3912 3914 -3154 111 3916 3915 3917 -3155 111 3919 3918 3920 -3156 111 3922 3921 3923 -3157 111 3925 3924 3926 -3158 111 3928 3927 3929 -3159 111 3931 3930 3932 -3160 111 3934 3933 3935 -3161 111 3937 3936 3938 -3162 111 3940 3939 3941 -3163 111 3943 3942 3944 -3164 111 3946 3945 3947 -3165 111 3949 3948 3950 -3166 111 3952 3951 3953 -3167 111 3955 3954 3956 -3168 111 3958 3957 3959 -3169 111 3961 3960 3962 -3170 111 3964 3963 3965 -3171 111 3967 3966 3968 -3172 111 3970 3969 3971 -3173 111 3973 3972 3974 -3174 111 3976 3975 3977 -3175 111 3979 3978 3980 -3176 111 3982 3981 3983 -3177 111 3985 3984 3986 -3178 111 3988 3987 3989 -3179 111 3991 3990 3992 -3180 111 3994 3993 3995 -3181 111 3997 3996 3998 -3182 111 4000 3999 4001 -3183 111 4003 4002 4004 -3184 111 4006 4005 4007 -3185 111 4009 4008 4010 -3186 111 4012 4011 4013 -3187 111 4015 4014 4016 -3188 111 4018 4017 4019 -3189 111 4021 4020 4022 -3190 111 4024 4023 4025 -3191 111 4027 4026 4028 -3192 111 4030 4029 4031 -3193 111 4033 4032 4034 -3194 111 4036 4035 4037 -3195 111 4039 4038 4040 -3196 111 4042 4041 4043 -3197 111 4045 4044 4046 -3198 111 4048 4047 4049 -3199 111 4051 4050 4052 -3200 111 4054 4053 4055 -3201 111 4057 4056 4058 -3202 111 4060 4059 4061 -3203 111 4063 4062 4064 -3204 111 4066 4065 4067 -3205 111 4069 4068 4070 -3206 111 4072 4071 4073 -3207 111 4075 4074 4076 -3208 111 4078 4077 4079 -3209 111 4081 4080 4082 -3210 111 4084 4083 4085 -3211 111 4087 4086 4088 -3212 111 4090 4089 4091 -3213 111 4093 4092 4094 -3214 111 4096 4095 4097 -3215 111 4099 4098 4100 -3216 111 4102 4101 4103 -3217 111 4105 4104 4106 -3218 111 4108 4107 4109 -3219 111 4111 4110 4112 -3220 111 4114 4113 4115 -3221 111 4117 4116 4118 -3222 111 4120 4119 4121 -3223 111 4123 4122 4124 -3224 111 4126 4125 4127 -3225 111 4129 4128 4130 -3226 111 4132 4131 4133 -3227 111 4135 4134 4136 -3228 111 4138 4137 4139 -3229 111 4141 4140 4142 -3230 111 4144 4143 4145 -3231 111 4147 4146 4148 -3232 111 4150 4149 4151 -3233 111 4153 4152 4154 -3234 111 4156 4155 4157 -3235 111 4159 4158 4160 -3236 111 4162 4161 4163 -3237 111 4165 4164 4166 -3238 111 4168 4167 4169 -3239 111 4171 4170 4172 -3240 111 4174 4173 4175 -3241 111 4177 4176 4178 -3242 111 4180 4179 4181 -3243 111 4183 4182 4184 -3244 111 4186 4185 4187 -3245 111 4189 4188 4190 -3246 111 4192 4191 4193 -3247 111 4195 4194 4196 -3248 111 4198 4197 4199 -3249 111 4201 4200 4202 -3250 111 4204 4203 4205 -3251 111 4207 4206 4208 -3252 111 4210 4209 4211 -3253 111 4213 4212 4214 -3254 111 4216 4215 4217 -3255 111 4219 4218 4220 -3256 111 4222 4221 4223 -3257 111 4225 4224 4226 -3258 111 4228 4227 4229 -3259 111 4231 4230 4232 -3260 111 4234 4233 4235 -3261 111 4237 4236 4238 -3262 111 4240 4239 4241 -3263 111 4243 4242 4244 -3264 111 4246 4245 4247 -3265 111 4249 4248 4250 -3266 111 4252 4251 4253 -3267 111 4255 4254 4256 -3268 111 4258 4257 4259 -3269 111 4261 4260 4262 -3270 111 4264 4263 4265 -3271 111 4267 4266 4268 -3272 111 4270 4269 4271 -3273 111 4273 4272 4274 -3274 111 4276 4275 4277 -3275 111 4279 4278 4280 -3276 111 4282 4281 4283 -3277 111 4285 4284 4286 -3278 111 4288 4287 4289 -3279 111 4291 4290 4292 -3280 111 4294 4293 4295 -3281 111 4297 4296 4298 -3282 111 4300 4299 4301 -3283 111 4303 4302 4304 -3284 111 4306 4305 4307 -3285 111 4309 4308 4310 -3286 111 4312 4311 4313 -3287 111 4315 4314 4316 -3288 111 4318 4317 4319 -3289 111 4321 4320 4322 -3290 111 4324 4323 4325 -3291 111 4327 4326 4328 -3292 111 4330 4329 4331 -3293 111 4333 4332 4334 -3294 111 4336 4335 4337 -3295 111 4339 4338 4340 -3296 111 4342 4341 4343 -3297 111 4345 4344 4346 -3298 111 4348 4347 4349 -3299 111 4351 4350 4352 -3300 111 4354 4353 4355 -3301 111 4357 4356 4358 -3302 111 4360 4359 4361 -3303 111 4363 4362 4364 -3304 111 4366 4365 4367 -3305 111 4369 4368 4370 -3306 111 4372 4371 4373 -3307 111 4375 4374 4376 -3308 111 4378 4377 4379 -3309 111 4381 4380 4382 -3310 111 4384 4383 4385 -3311 111 4387 4386 4388 -3312 111 4390 4389 4391 -3313 111 4393 4392 4394 -3314 111 4396 4395 4397 -3315 111 4399 4398 4400 -3316 111 4402 4401 4403 -3317 111 4405 4404 4406 -3318 111 4408 4407 4409 -3319 111 4411 4410 4412 -3320 111 4414 4413 4415 -3321 111 4417 4416 4418 -3322 111 4420 4419 4421 -3323 111 4423 4422 4424 -3324 111 4426 4425 4427 -3325 111 4429 4428 4430 -3326 111 4432 4431 4433 -3327 111 4435 4434 4436 -3328 111 4438 4437 4439 -3329 111 4441 4440 4442 -3330 111 4444 4443 4445 -3331 111 4447 4446 4448 -3332 111 4450 4449 4451 -3333 111 4453 4452 4454 -3334 111 4456 4455 4457 -3335 111 4459 4458 4460 -3336 111 4462 4461 4463 -3337 111 4465 4464 4466 -3338 111 4468 4467 4469 -3339 111 4471 4470 4472 -3340 111 4474 4473 4475 -3341 111 4477 4476 4478 -3342 111 4480 4479 4481 -3343 111 4483 4482 4484 -3344 111 4486 4485 4487 -3345 111 4489 4488 4490 -3346 111 4492 4491 4493 -3347 111 4495 4494 4496 -3348 111 4498 4497 4499 -3349 111 4501 4500 4502 -3350 111 4504 4503 4505 -3351 111 4507 4506 4508 -3352 111 4510 4509 4511 -3353 111 4513 4512 4514 -3354 111 4516 4515 4517 -3355 111 4519 4518 4520 -3356 111 4522 4521 4523 -3357 111 4525 4524 4526 -3358 111 4528 4527 4529 -3359 111 4531 4530 4532 -3360 111 4534 4533 4535 -3361 111 4537 4536 4538 -3362 111 4540 4539 4541 -3363 111 4543 4542 4544 -3364 111 4546 4545 4547 -3365 111 4549 4548 4550 -3366 111 4552 4551 4553 -3367 111 4555 4554 4556 -3368 111 4558 4557 4559 -3369 111 4561 4560 4562 -3370 111 4564 4563 4565 -3371 111 4567 4566 4568 -3372 111 4570 4569 4571 -3373 111 4573 4572 4574 -3374 111 4576 4575 4577 -3375 111 4579 4578 4580 -3376 111 4582 4581 4583 -3377 111 4585 4584 4586 -3378 111 4588 4587 4589 -3379 111 4591 4590 4592 -3380 111 4594 4593 4595 -3381 111 4597 4596 4598 -3382 111 4600 4599 4601 -3383 111 4603 4602 4604 -3384 111 4606 4605 4607 -3385 111 4609 4608 4610 -3386 111 4612 4611 4613 -3387 111 4615 4614 4616 -3388 111 4618 4617 4619 -3389 111 4621 4620 4622 -3390 111 4624 4623 4625 -3391 111 4627 4626 4628 -3392 111 4630 4629 4631 -3393 111 4633 4632 4634 -3394 111 4636 4635 4637 -3395 111 4639 4638 4640 -3396 111 4642 4641 4643 -3397 111 4645 4644 4646 -3398 111 4648 4647 4649 -3399 111 4651 4650 4652 -3400 111 4654 4653 4655 -3401 111 4657 4656 4658 -3402 111 4660 4659 4661 -3403 111 4663 4662 4664 -3404 111 4666 4665 4667 -3405 111 4669 4668 4670 -3406 111 4672 4671 4673 -3407 111 4675 4674 4676 -3408 111 4678 4677 4679 -3409 111 4681 4680 4682 -3410 111 4684 4683 4685 -3411 111 4687 4686 4688 -3412 111 4690 4689 4691 -3413 111 4693 4692 4694 -3414 111 4696 4695 4697 -3415 111 4699 4698 4700 -3416 111 4702 4701 4703 -3417 111 4705 4704 4706 -3418 111 4708 4707 4709 -3419 111 4711 4710 4712 -3420 111 4714 4713 4715 -3421 111 4717 4716 4718 -3422 111 4720 4719 4721 -3423 111 4723 4722 4724 -3424 111 4726 4725 4727 -3425 111 4729 4728 4730 -3426 111 4732 4731 4733 -3427 111 4735 4734 4736 -3428 111 4738 4737 4739 -3429 111 4741 4740 4742 -3430 111 4744 4743 4745 -3431 111 4747 4746 4748 -3432 111 4750 4749 4751 -3433 111 4753 4752 4754 -3434 111 4756 4755 4757 -3435 111 4759 4758 4760 -3436 111 4762 4761 4763 -3437 111 4765 4764 4766 -3438 111 4768 4767 4769 -3439 111 4771 4770 4772 -3440 111 4774 4773 4775 -3441 111 4777 4776 4778 -3442 111 4780 4779 4781 -3443 111 4783 4782 4784 -3444 111 4786 4785 4787 -3445 111 4789 4788 4790 -3446 111 4792 4791 4793 -3447 111 4795 4794 4796 -3448 111 4798 4797 4799 -3449 111 4801 4800 4802 -3450 111 4804 4803 4805 -3451 111 4807 4806 4808 -3452 111 4810 4809 4811 -3453 111 4813 4812 4814 -3454 111 4816 4815 4817 -3455 111 4819 4818 4820 -3456 111 4822 4821 4823 -3457 111 4825 4824 4826 -3458 111 4828 4827 4829 -3459 111 4831 4830 4832 -3460 111 4834 4833 4835 -3461 111 4837 4836 4838 -3462 111 4840 4839 4841 -3463 111 4843 4842 4844 -3464 111 4846 4845 4847 -3465 111 4849 4848 4850 -3466 111 4852 4851 4853 -3467 111 4855 4854 4856 -3468 111 4858 4857 4859 -3469 111 4861 4860 4862 -3470 111 4864 4863 4865 -3471 111 4867 4866 4868 -3472 111 4870 4869 4871 -3473 111 4873 4872 4874 -3474 111 4876 4875 4877 -3475 111 4879 4878 4880 -3476 111 4882 4881 4883 -3477 111 4885 4884 4886 -3478 111 4888 4887 4889 -3479 111 4891 4890 4892 -3480 111 4894 4893 4895 -3481 111 4897 4896 4898 -3482 111 4900 4899 4901 -3483 111 4903 4902 4904 -3484 111 4906 4905 4907 -3485 111 4909 4908 4910 -3486 111 4912 4911 4913 -3487 111 4915 4914 4916 -3488 111 4918 4917 4919 -3489 111 4921 4920 4922 -3490 111 4924 4923 4925 -3491 111 4927 4926 4928 -3492 111 4930 4929 4931 -3493 111 4933 4932 4934 -3494 111 4936 4935 4937 -3495 111 4939 4938 4940 -3496 111 4942 4941 4943 -3497 111 4945 4944 4946 -3498 111 4948 4947 4949 -3499 111 4951 4950 4952 -3500 111 4954 4953 4955 -3501 111 4957 4956 4958 -3502 111 4960 4959 4961 -3503 111 4963 4962 4964 -3504 111 4966 4965 4967 -3505 111 4969 4968 4970 -3506 111 4972 4971 4973 -3507 111 4975 4974 4976 -3508 111 4978 4977 4979 -3509 111 4981 4980 4982 -3510 111 4984 4983 4985 -3511 111 4987 4986 4988 -3512 111 4990 4989 4991 -3513 111 4993 4992 4994 -3514 111 4996 4995 4997 -3515 111 4999 4998 5000 -3516 111 5002 5001 5003 -3517 111 5005 5004 5006 -3518 111 5008 5007 5009 -3519 111 5011 5010 5012 -3520 111 5014 5013 5015 -3521 111 5017 5016 5018 -3522 111 5020 5019 5021 -3523 111 5023 5022 5024 -3524 111 5026 5025 5027 -3525 111 5029 5028 5030 -3526 111 5032 5031 5033 -3527 111 5035 5034 5036 -3528 111 5038 5037 5039 -3529 111 5041 5040 5042 -3530 111 5044 5043 5045 -3531 111 5047 5046 5048 -3532 111 5050 5049 5051 -3533 111 5053 5052 5054 -3534 111 5056 5055 5057 -3535 111 5059 5058 5060 -3536 111 5062 5061 5063 -3537 111 5065 5064 5066 -3538 111 5068 5067 5069 -3539 111 5071 5070 5072 -3540 111 5074 5073 5075 -3541 111 5077 5076 5078 -3542 111 5080 5079 5081 -3543 111 5083 5082 5084 -3544 111 5086 5085 5087 -3545 111 5089 5088 5090 -3546 111 5092 5091 5093 -3547 111 5095 5094 5096 -3548 111 5098 5097 5099 -3549 111 5101 5100 5102 -3550 111 5104 5103 5105 -3551 111 5107 5106 5108 -3552 111 5110 5109 5111 -3553 111 5113 5112 5114 -3554 111 5116 5115 5117 -3555 111 5119 5118 5120 -3556 111 5122 5121 5123 -3557 111 5125 5124 5126 -3558 111 5128 5127 5129 -3559 111 5131 5130 5132 -3560 111 5134 5133 5135 -3561 111 5137 5136 5138 -3562 111 5140 5139 5141 -3563 111 5143 5142 5144 -3564 111 5146 5145 5147 -3565 111 5149 5148 5150 -3566 111 5152 5151 5153 -3567 111 5155 5154 5156 -3568 111 5158 5157 5159 -3569 111 5161 5160 5162 -3570 111 5164 5163 5165 -3571 111 5167 5166 5168 -3572 111 5170 5169 5171 -3573 111 5173 5172 5174 -3574 111 5176 5175 5177 -3575 111 5179 5178 5180 -3576 111 5182 5181 5183 -3577 111 5185 5184 5186 -3578 111 5188 5187 5189 -3579 111 5191 5190 5192 -3580 111 5194 5193 5195 -3581 111 5197 5196 5198 -3582 111 5200 5199 5201 -3583 111 5203 5202 5204 -3584 111 5206 5205 5207 -3585 111 5209 5208 5210 -3586 111 5212 5211 5213 -3587 111 5215 5214 5216 -3588 111 5218 5217 5219 -3589 111 5221 5220 5222 -3590 111 5224 5223 5225 -3591 111 5227 5226 5228 -3592 111 5230 5229 5231 -3593 111 5233 5232 5234 -3594 111 5236 5235 5237 -3595 111 5239 5238 5240 -3596 111 5242 5241 5243 -3597 111 5245 5244 5246 -3598 111 5248 5247 5249 -3599 111 5251 5250 5252 -3600 111 5254 5253 5255 -3601 111 5257 5256 5258 -3602 111 5260 5259 5261 -3603 111 5263 5262 5264 -3604 111 5266 5265 5267 -3605 111 5269 5268 5270 -3606 111 5272 5271 5273 -3607 111 5275 5274 5276 -3608 111 5278 5277 5279 -3609 111 5281 5280 5282 -3610 111 5284 5283 5285 -3611 111 5287 5286 5288 -3612 111 5290 5289 5291 -3613 111 5293 5292 5294 -3614 111 5296 5295 5297 -3615 111 5299 5298 5300 -3616 111 5302 5301 5303 -3617 111 5305 5304 5306 -3618 111 5308 5307 5309 -3619 111 5311 5310 5312 -3620 111 5314 5313 5315 -3621 111 5317 5316 5318 -3622 111 5320 5319 5321 -3623 111 5323 5322 5324 -3624 111 5326 5325 5327 -3625 111 5329 5328 5330 -3626 111 5332 5331 5333 -3627 111 5335 5334 5336 -3628 111 5338 5337 5339 -3629 111 5341 5340 5342 -3630 111 5344 5343 5345 -3631 111 5347 5346 5348 -3632 111 5350 5349 5351 -3633 111 5353 5352 5354 -3634 111 5356 5355 5357 -3635 111 5359 5358 5360 -3636 111 5362 5361 5363 -3637 111 5365 5364 5366 -3638 111 5368 5367 5369 -3639 111 5371 5370 5372 -3640 111 5374 5373 5375 -3641 111 5377 5376 5378 -3642 111 5380 5379 5381 -3643 111 5383 5382 5384 -3644 111 5386 5385 5387 -3645 111 5389 5388 5390 -3646 111 5392 5391 5393 -3647 111 5395 5394 5396 -3648 111 5398 5397 5399 -3649 111 5401 5400 5402 -3650 111 5404 5403 5405 -3651 111 5407 5406 5408 -3652 111 5410 5409 5411 -3653 111 5413 5412 5414 -3654 111 5416 5415 5417 -3655 111 5419 5418 5420 -3656 111 5422 5421 5423 -3657 111 5425 5424 5426 -3658 111 5428 5427 5429 -3659 111 5431 5430 5432 -3660 111 5434 5433 5435 -3661 111 5437 5436 5438 -3662 111 5440 5439 5441 -3663 111 5443 5442 5444 -3664 111 5446 5445 5447 -3665 111 5449 5448 5450 -3666 111 5452 5451 5453 -3667 111 5455 5454 5456 -3668 111 5458 5457 5459 -3669 111 5461 5460 5462 -3670 111 5464 5463 5465 -3671 111 5467 5466 5468 -3672 111 5470 5469 5471 -3673 111 5473 5472 5474 -3674 111 5476 5475 5477 -3675 111 5479 5478 5480 -3676 111 5482 5481 5483 -3677 111 5485 5484 5486 -3678 111 5488 5487 5489 -3679 111 5491 5490 5492 -3680 111 5494 5493 5495 -3681 111 5497 5496 5498 -3682 111 5500 5499 5501 -3683 111 5503 5502 5504 -3684 111 5506 5505 5507 -3685 111 5509 5508 5510 -3686 111 5512 5511 5513 -3687 111 5515 5514 5516 -3688 111 5518 5517 5519 -3689 111 5521 5520 5522 -3690 111 5524 5523 5525 -3691 111 5527 5526 5528 -3692 111 5530 5529 5531 -3693 111 5533 5532 5534 -3694 111 5536 5535 5537 -3695 111 5539 5538 5540 -3696 111 5542 5541 5543 -3697 111 5545 5544 5546 -3698 111 5548 5547 5549 -3699 111 5551 5550 5552 -3700 111 5554 5553 5555 -3701 111 5557 5556 5558 -3702 111 5560 5559 5561 -3703 111 5563 5562 5564 -3704 111 5566 5565 5567 -3705 111 5569 5568 5570 -3706 111 5572 5571 5573 -3707 111 5575 5574 5576 -3708 111 5578 5577 5579 -3709 111 5581 5580 5582 -3710 111 5584 5583 5585 -3711 111 5587 5586 5588 -3712 111 5590 5589 5591 -3713 111 5593 5592 5594 -3714 111 5596 5595 5597 -3715 111 5599 5598 5600 -3716 111 5602 5601 5603 -3717 111 5605 5604 5606 -3718 111 5608 5607 5609 -3719 111 5611 5610 5612 -3720 111 5614 5613 5615 -3721 111 5617 5616 5618 -3722 111 5620 5619 5621 -3723 111 5623 5622 5624 -3724 111 5626 5625 5627 -3725 111 5629 5628 5630 -3726 111 5632 5631 5633 -3727 111 5635 5634 5636 -3728 111 5638 5637 5639 -3729 111 5641 5640 5642 -3730 111 5644 5643 5645 -3731 111 5647 5646 5648 -3732 111 5650 5649 5651 -3733 111 5653 5652 5654 -3734 111 5656 5655 5657 -3735 111 5659 5658 5660 -3736 111 5662 5661 5663 -3737 111 5665 5664 5666 -3738 111 5668 5667 5669 -3739 111 5671 5670 5672 -3740 111 5674 5673 5675 -3741 111 5677 5676 5678 -3742 111 5680 5679 5681 -3743 111 5683 5682 5684 -3744 111 5686 5685 5687 -3745 111 5689 5688 5690 -3746 111 5692 5691 5693 -3747 111 5695 5694 5696 -3748 111 5698 5697 5699 -3749 111 5701 5700 5702 -3750 111 5704 5703 5705 -3751 111 5707 5706 5708 -3752 111 5710 5709 5711 -3753 111 5713 5712 5714 -3754 111 5716 5715 5717 -3755 111 5719 5718 5720 -3756 111 5722 5721 5723 -3757 111 5725 5724 5726 -3758 111 5728 5727 5729 -3759 111 5731 5730 5732 -3760 111 5734 5733 5735 -3761 111 5737 5736 5738 -3762 111 5740 5739 5741 -3763 111 5743 5742 5744 -3764 111 5746 5745 5747 -3765 111 5749 5748 5750 -3766 111 5752 5751 5753 -3767 111 5755 5754 5756 -3768 111 5758 5757 5759 -3769 111 5761 5760 5762 -3770 111 5764 5763 5765 -3771 111 5767 5766 5768 -3772 111 5770 5769 5771 -3773 111 5773 5772 5774 -3774 111 5776 5775 5777 -3775 111 5779 5778 5780 -3776 111 5782 5781 5783 -3777 111 5785 5784 5786 -3778 111 5788 5787 5789 -3779 111 5791 5790 5792 -3780 111 5794 5793 5795 -3781 111 5797 5796 5798 -3782 111 5800 5799 5801 -3783 111 5803 5802 5804 -3784 111 5806 5805 5807 -3785 111 5809 5808 5810 -3786 111 5812 5811 5813 -3787 111 5815 5814 5816 -3788 111 5818 5817 5819 -3789 111 5821 5820 5822 -3790 111 5824 5823 5825 -3791 111 5827 5826 5828 -3792 111 5830 5829 5831 -3793 111 5833 5832 5834 -3794 111 5836 5835 5837 -3795 111 5839 5838 5840 -3796 111 5842 5841 5843 -3797 111 5845 5844 5846 -3798 111 5848 5847 5849 -3799 111 5851 5850 5852 -3800 111 5854 5853 5855 -3801 111 5857 5856 5858 -3802 111 5860 5859 5861 -3803 111 5863 5862 5864 -3804 111 5866 5865 5867 -3805 111 5869 5868 5870 -3806 111 5872 5871 5873 -3807 111 5875 5874 5876 -3808 111 5878 5877 5879 -3809 111 5881 5880 5882 -3810 111 5884 5883 5885 -3811 111 5887 5886 5888 -3812 111 5890 5889 5891 -3813 111 5893 5892 5894 -3814 111 5896 5895 5897 -3815 111 5899 5898 5900 -3816 111 5902 5901 5903 -3817 111 5905 5904 5906 -3818 111 5908 5907 5909 -3819 111 5911 5910 5912 -3820 111 5914 5913 5915 -3821 111 5917 5916 5918 -3822 111 5920 5919 5921 -3823 111 5923 5922 5924 -3824 111 5926 5925 5927 -3825 111 5929 5928 5930 -3826 111 5932 5931 5933 -3827 111 5935 5934 5936 -3828 111 5938 5937 5939 -3829 111 5941 5940 5942 -3830 111 5944 5943 5945 -3831 111 5947 5946 5948 -3832 111 5950 5949 5951 -3833 111 5953 5952 5954 -3834 111 5956 5955 5957 -3835 111 5959 5958 5960 -3836 111 5962 5961 5963 -3837 111 5965 5964 5966 -3838 111 5968 5967 5969 -3839 111 5971 5970 5972 -3840 111 5974 5973 5975 -3841 111 5977 5976 5978 -3842 111 5980 5979 5981 -3843 111 5983 5982 5984 -3844 111 5986 5985 5987 -3845 111 5989 5988 5990 -3846 111 5992 5991 5993 -3847 111 5995 5994 5996 -3848 111 5998 5997 5999 -3849 111 6001 6000 6002 -3850 111 6004 6003 6005 -3851 111 6007 6006 6008 -3852 111 6010 6009 6011 -3853 111 6013 6012 6014 -3854 111 6016 6015 6017 -3855 111 6019 6018 6020 -3856 111 6022 6021 6023 -3857 111 6025 6024 6026 -3858 111 6028 6027 6029 -3859 111 6031 6030 6032 -3860 111 6034 6033 6035 -3861 111 6037 6036 6038 -3862 111 6040 6039 6041 -3863 111 6043 6042 6044 -3864 111 6046 6045 6047 -3865 111 6049 6048 6050 -3866 111 6052 6051 6053 -3867 111 6055 6054 6056 -3868 111 6058 6057 6059 -3869 111 6061 6060 6062 -3870 111 6064 6063 6065 -3871 111 6067 6066 6068 -3872 111 6070 6069 6071 -3873 111 6073 6072 6074 -3874 111 6076 6075 6077 -3875 111 6079 6078 6080 -3876 111 6082 6081 6083 -3877 111 6085 6084 6086 -3878 111 6088 6087 6089 -3879 111 6091 6090 6092 -3880 111 6094 6093 6095 -3881 111 6097 6096 6098 -3882 111 6100 6099 6101 -3883 111 6103 6102 6104 -3884 111 6106 6105 6107 -3885 111 6109 6108 6110 -3886 111 6112 6111 6113 -3887 111 6115 6114 6116 -3888 111 6118 6117 6119 -3889 111 6121 6120 6122 -3890 111 6124 6123 6125 -3891 111 6127 6126 6128 -3892 111 6130 6129 6131 -3893 111 6133 6132 6134 -3894 111 6136 6135 6137 -3895 111 6139 6138 6140 -3896 111 6142 6141 6143 -3897 111 6145 6144 6146 -3898 111 6148 6147 6149 -3899 111 6151 6150 6152 -3900 111 6154 6153 6155 -3901 111 6157 6156 6158 -3902 111 6160 6159 6161 -3903 111 6163 6162 6164 -3904 111 6166 6165 6167 -3905 111 6169 6168 6170 -3906 111 6172 6171 6173 -3907 111 6175 6174 6176 -3908 111 6178 6177 6179 -3909 111 6181 6180 6182 -3910 111 6184 6183 6185 -3911 111 6187 6186 6188 -3912 111 6190 6189 6191 -3913 111 6193 6192 6194 -3914 111 6196 6195 6197 -3915 111 6199 6198 6200 -3916 111 6202 6201 6203 -3917 111 6205 6204 6206 -3918 111 6208 6207 6209 -3919 111 6211 6210 6212 -3920 111 6214 6213 6215 -3921 111 6217 6216 6218 -3922 111 6220 6219 6221 -3923 111 6223 6222 6224 -3924 111 6226 6225 6227 -3925 111 6229 6228 6230 -3926 111 6232 6231 6233 -3927 111 6235 6234 6236 -3928 111 6238 6237 6239 -3929 111 6241 6240 6242 -3930 111 6244 6243 6245 -3931 111 6247 6246 6248 -3932 111 6250 6249 6251 -3933 111 6253 6252 6254 -3934 111 6256 6255 6257 -3935 111 6259 6258 6260 -3936 111 6262 6261 6263 -3937 111 6265 6264 6266 -3938 111 6268 6267 6269 -3939 111 6271 6270 6272 -3940 111 6274 6273 6275 -3941 111 6277 6276 6278 -3942 111 6280 6279 6281 -3943 111 6283 6282 6284 -3944 111 6286 6285 6287 -3945 111 6289 6288 6290 -3946 111 6292 6291 6293 -3947 111 6295 6294 6296 -3948 111 6298 6297 6299 -3949 111 6301 6300 6302 -3950 111 6304 6303 6305 -3951 111 6307 6306 6308 -3952 111 6310 6309 6311 -3953 111 6313 6312 6314 -3954 111 6316 6315 6317 -3955 111 6319 6318 6320 -3956 111 6322 6321 6323 -3957 111 6325 6324 6326 -3958 111 6328 6327 6329 -3959 111 6331 6330 6332 -3960 111 6334 6333 6335 -3961 111 6337 6336 6338 -3962 111 6340 6339 6341 -3963 111 6343 6342 6344 -3964 111 6346 6345 6347 -3965 111 6349 6348 6350 -3966 111 6352 6351 6353 -3967 111 6355 6354 6356 -3968 111 6358 6357 6359 -3969 111 6361 6360 6362 -3970 111 6364 6363 6365 -3971 111 6367 6366 6368 -3972 111 6370 6369 6371 -3973 111 6373 6372 6374 -3974 111 6376 6375 6377 -3975 111 6379 6378 6380 -3976 111 6382 6381 6383 -3977 111 6385 6384 6386 -3978 111 6388 6387 6389 -3979 111 6391 6390 6392 -3980 111 6394 6393 6395 -3981 111 6397 6396 6398 -3982 111 6400 6399 6401 -3983 111 6403 6402 6404 -3984 111 6406 6405 6407 -3985 111 6409 6408 6410 -3986 111 6412 6411 6413 -3987 111 6415 6414 6416 -3988 111 6418 6417 6419 -3989 111 6421 6420 6422 -3990 111 6424 6423 6425 -3991 111 6427 6426 6428 -3992 111 6430 6429 6431 -3993 111 6433 6432 6434 -3994 111 6436 6435 6437 -3995 111 6439 6438 6440 -3996 111 6442 6441 6443 -3997 111 6445 6444 6446 -3998 111 6448 6447 6449 -3999 111 6451 6450 6452 -4000 111 6454 6453 6455 -4001 111 6457 6456 6458 -4002 111 6460 6459 6461 -4003 111 6463 6462 6464 -4004 111 6466 6465 6467 -4005 111 6469 6468 6470 -4006 111 6472 6471 6473 -4007 111 6475 6474 6476 -4008 111 6478 6477 6479 -4009 111 6481 6480 6482 -4010 111 6484 6483 6485 -4011 111 6487 6486 6488 -4012 111 6490 6489 6491 -4013 111 6493 6492 6494 -4014 111 6496 6495 6497 -4015 111 6499 6498 6500 -4016 111 6502 6501 6503 -4017 111 6505 6504 6506 -4018 111 6508 6507 6509 -4019 111 6511 6510 6512 -4020 111 6514 6513 6515 -4021 111 6517 6516 6518 -4022 111 6520 6519 6521 -4023 111 6523 6522 6524 -4024 111 6526 6525 6527 -4025 111 6529 6528 6530 -4026 111 6532 6531 6533 -4027 111 6535 6534 6536 -4028 111 6538 6537 6539 -4029 111 6541 6540 6542 -4030 111 6544 6543 6545 -4031 111 6547 6546 6548 -4032 111 6550 6549 6551 -4033 111 6553 6552 6554 -4034 111 6556 6555 6557 -4035 111 6559 6558 6560 -4036 111 6562 6561 6563 -4037 111 6565 6564 6566 -4038 111 6568 6567 6569 -4039 111 6571 6570 6572 -4040 111 6574 6573 6575 -4041 111 6577 6576 6578 -4042 111 6580 6579 6581 -4043 111 6583 6582 6584 -4044 111 6586 6585 6587 -4045 111 6589 6588 6590 -4046 111 6592 6591 6593 -4047 111 6595 6594 6596 -4048 111 6598 6597 6599 -4049 111 6601 6600 6602 -4050 111 6604 6603 6605 -4051 111 6607 6606 6608 -4052 111 6610 6609 6611 -4053 111 6613 6612 6614 -4054 111 6616 6615 6617 -4055 111 6619 6618 6620 -4056 111 6622 6621 6623 -4057 111 6625 6624 6626 -4058 111 6628 6627 6629 -4059 111 6631 6630 6632 -4060 111 6634 6633 6635 -4061 111 6637 6636 6638 -4062 111 6640 6639 6641 -4063 111 6643 6642 6644 -4064 111 6646 6645 6647 -4065 111 6649 6648 6650 -4066 111 6652 6651 6653 -4067 111 6655 6654 6656 -4068 111 6658 6657 6659 -4069 111 6661 6660 6662 -4070 111 6664 6663 6665 -4071 111 6667 6666 6668 -4072 111 6670 6669 6671 -4073 111 6673 6672 6674 -4074 111 6676 6675 6677 -4075 111 6679 6678 6680 -4076 111 6682 6681 6683 -4077 111 6685 6684 6686 -4078 111 6688 6687 6689 -4079 111 6691 6690 6692 -4080 111 6694 6693 6695 -4081 111 6697 6696 6698 -4082 111 6700 6699 6701 -4083 111 6703 6702 6704 -4084 111 6706 6705 6707 -4085 111 6709 6708 6710 -4086 111 6712 6711 6713 -4087 111 6715 6714 6716 -4088 111 6718 6717 6719 -4089 111 6721 6720 6722 -4090 111 6724 6723 6725 -4091 111 6727 6726 6728 -4092 111 6730 6729 6731 -4093 111 6733 6732 6734 -4094 111 6736 6735 6737 -4095 111 6739 6738 6740 -4096 111 6742 6741 6743 -4097 111 6745 6744 6746 -4098 111 6748 6747 6749 -4099 111 6751 6750 6752 -4100 111 6754 6753 6755 -4101 111 6757 6756 6758 -4102 111 6760 6759 6761 -4103 111 6763 6762 6764 -4104 111 6766 6765 6767 -4105 111 6769 6768 6770 -4106 111 6772 6771 6773 -4107 111 6775 6774 6776 -4108 111 6778 6777 6779 -4109 111 6781 6780 6782 -4110 111 6784 6783 6785 -4111 111 6787 6786 6788 -4112 111 6790 6789 6791 -4113 111 6793 6792 6794 -4114 111 6796 6795 6797 -4115 111 6799 6798 6800 -4116 111 6802 6801 6803 -4117 111 6805 6804 6806 -4118 111 6808 6807 6809 -4119 111 6811 6810 6812 -4120 111 6814 6813 6815 -4121 111 6817 6816 6818 -4122 111 6820 6819 6821 -4123 111 6823 6822 6824 -4124 111 6826 6825 6827 -4125 111 6829 6828 6830 -4126 111 6832 6831 6833 -4127 111 6835 6834 6836 -4128 111 6838 6837 6839 -4129 111 6841 6840 6842 -4130 111 6844 6843 6845 -4131 111 6847 6846 6848 -4132 111 6850 6849 6851 -4133 111 6853 6852 6854 -4134 111 6856 6855 6857 -4135 111 6859 6858 6860 -4136 111 6862 6861 6863 -4137 111 6865 6864 6866 -4138 111 6868 6867 6869 -4139 111 6871 6870 6872 -4140 111 6874 6873 6875 -4141 111 6877 6876 6878 -4142 111 6880 6879 6881 -4143 111 6883 6882 6884 -4144 111 6886 6885 6887 -4145 111 6889 6888 6890 -4146 111 6892 6891 6893 -4147 111 6895 6894 6896 -4148 111 6898 6897 6899 -4149 111 6901 6900 6902 -4150 111 6904 6903 6905 -4151 111 6907 6906 6908 -4152 111 6910 6909 6911 -4153 111 6913 6912 6914 -4154 111 6916 6915 6917 -4155 111 6919 6918 6920 -4156 111 6922 6921 6923 -4157 111 6925 6924 6926 -4158 111 6928 6927 6929 -4159 111 6931 6930 6932 -4160 111 6934 6933 6935 -4161 111 6937 6936 6938 -4162 111 6940 6939 6941 -4163 111 6943 6942 6944 -4164 111 6946 6945 6947 -4165 111 6949 6948 6950 -4166 111 6952 6951 6953 -4167 111 6955 6954 6956 -4168 111 6958 6957 6959 -4169 111 6961 6960 6962 -4170 111 6964 6963 6965 -4171 111 6967 6966 6968 -4172 111 6970 6969 6971 -4173 111 6973 6972 6974 -4174 111 6976 6975 6977 -4175 111 6979 6978 6980 -4176 111 6982 6981 6983 -4177 111 6985 6984 6986 -4178 111 6988 6987 6989 -4179 111 6991 6990 6992 -4180 111 6994 6993 6995 -4181 111 6997 6996 6998 -4182 111 7000 6999 7001 -4183 111 7003 7002 7004 -4184 111 7006 7005 7007 -4185 111 7009 7008 7010 -4186 111 7012 7011 7013 -4187 111 7015 7014 7016 -4188 111 7018 7017 7019 -4189 111 7021 7020 7022 -4190 111 7024 7023 7025 -4191 111 7027 7026 7028 -4192 111 7030 7029 7031 -4193 111 7033 7032 7034 -4194 111 7036 7035 7037 -4195 111 7039 7038 7040 -4196 111 7042 7041 7043 -4197 111 7045 7044 7046 -4198 111 7048 7047 7049 -4199 111 7051 7050 7052 -4200 111 7054 7053 7055 -4201 111 7057 7056 7058 -4202 111 7060 7059 7061 -4203 111 7063 7062 7064 -4204 111 7066 7065 7067 -4205 111 7069 7068 7070 -4206 111 7072 7071 7073 -4207 111 7075 7074 7076 -4208 111 7078 7077 7079 -4209 111 7081 7080 7082 -4210 111 7084 7083 7085 -4211 111 7087 7086 7088 -4212 111 7090 7089 7091 -4213 111 7093 7092 7094 -4214 111 7096 7095 7097 -4215 111 7099 7098 7100 -4216 111 7102 7101 7103 -4217 111 7105 7104 7106 -4218 111 7108 7107 7109 -4219 111 7111 7110 7112 -4220 111 7114 7113 7115 -4221 111 7117 7116 7118 -4222 111 7120 7119 7121 -4223 111 7123 7122 7124 -4224 111 7126 7125 7127 -4225 111 7129 7128 7130 -4226 111 7132 7131 7133 -4227 111 7135 7134 7136 -4228 111 7138 7137 7139 -4229 111 7141 7140 7142 -4230 111 7144 7143 7145 -4231 111 7147 7146 7148 -4232 111 7150 7149 7151 -4233 111 7153 7152 7154 -4234 111 7156 7155 7157 -4235 111 7159 7158 7160 -4236 111 7162 7161 7163 -4237 111 7165 7164 7166 -4238 111 7168 7167 7169 -4239 111 7171 7170 7172 -4240 111 7174 7173 7175 -4241 111 7177 7176 7178 -4242 111 7180 7179 7181 -4243 111 7183 7182 7184 -4244 111 7186 7185 7187 -4245 111 7189 7188 7190 -4246 111 7192 7191 7193 -4247 111 7195 7194 7196 -4248 111 7198 7197 7199 -4249 111 7201 7200 7202 -4250 111 7204 7203 7205 -4251 111 7207 7206 7208 -4252 111 7210 7209 7211 -4253 111 7213 7212 7214 -4254 111 7216 7215 7217 -4255 111 7219 7218 7220 -4256 111 7222 7221 7223 -4257 111 7225 7224 7226 -4258 111 7228 7227 7229 -4259 111 7231 7230 7232 -4260 111 7234 7233 7235 -4261 111 7237 7236 7238 -4262 111 7240 7239 7241 -4263 111 7243 7242 7244 -4264 111 7246 7245 7247 -4265 111 7249 7248 7250 -4266 111 7252 7251 7253 -4267 111 7255 7254 7256 -4268 111 7258 7257 7259 -4269 111 7261 7260 7262 -4270 111 7264 7263 7265 -4271 111 7267 7266 7268 -4272 111 7270 7269 7271 -4273 111 7273 7272 7274 -4274 111 7276 7275 7277 -4275 111 7279 7278 7280 -4276 111 7282 7281 7283 -4277 111 7285 7284 7286 -4278 111 7288 7287 7289 -4279 111 7291 7290 7292 -4280 111 7294 7293 7295 -4281 111 7297 7296 7298 -4282 111 7300 7299 7301 -4283 111 7303 7302 7304 -4284 111 7306 7305 7307 -4285 111 7309 7308 7310 -4286 111 7312 7311 7313 -4287 111 7315 7314 7316 -4288 111 7318 7317 7319 -4289 111 7321 7320 7322 -4290 111 7324 7323 7325 -4291 111 7327 7326 7328 -4292 111 7330 7329 7331 -4293 111 7333 7332 7334 -4294 111 7336 7335 7337 -4295 111 7339 7338 7340 -4296 111 7342 7341 7343 -4297 111 7345 7344 7346 -4298 111 7348 7347 7349 -4299 111 7351 7350 7352 -4300 111 7354 7353 7355 -4301 111 7357 7356 7358 -4302 111 7360 7359 7361 -4303 111 7363 7362 7364 -4304 111 7366 7365 7367 -4305 111 7369 7368 7370 -4306 111 7372 7371 7373 -4307 111 7375 7374 7376 -4308 111 7378 7377 7379 -4309 111 7381 7380 7382 -4310 111 7384 7383 7385 -4311 111 7387 7386 7388 -4312 111 7390 7389 7391 -4313 111 7393 7392 7394 -4314 111 7396 7395 7397 -4315 111 7399 7398 7400 -4316 111 7402 7401 7403 -4317 111 7405 7404 7406 -4318 111 7408 7407 7409 -4319 111 7411 7410 7412 -4320 111 7414 7413 7415 -4321 111 7417 7416 7418 -4322 111 7420 7419 7421 -4323 111 7423 7422 7424 -4324 111 7426 7425 7427 -4325 111 7429 7428 7430 -4326 111 7432 7431 7433 -4327 111 7435 7434 7436 -4328 111 7438 7437 7439 -4329 111 7441 7440 7442 -4330 111 7444 7443 7445 -4331 111 7447 7446 7448 -4332 111 7450 7449 7451 -4333 111 7453 7452 7454 -4334 111 7456 7455 7457 -4335 111 7459 7458 7460 -4336 111 7462 7461 7463 -4337 111 7465 7464 7466 -4338 111 7468 7467 7469 -4339 111 7471 7470 7472 -4340 111 7474 7473 7475 -4341 111 7477 7476 7478 -4342 111 7480 7479 7481 -4343 111 7483 7482 7484 -4344 111 7486 7485 7487 -4345 111 7489 7488 7490 -4346 111 7492 7491 7493 -4347 111 7495 7494 7496 -4348 111 7498 7497 7499 -4349 111 7501 7500 7502 -4350 111 7504 7503 7505 -4351 111 7507 7506 7508 -4352 111 7510 7509 7511 -4353 111 7513 7512 7514 -4354 111 7516 7515 7517 -4355 111 7519 7518 7520 -4356 111 7522 7521 7523 -4357 111 7525 7524 7526 -4358 111 7528 7527 7529 -4359 111 7531 7530 7532 -4360 111 7534 7533 7535 -4361 111 7537 7536 7538 -4362 111 7540 7539 7541 -4363 111 7543 7542 7544 -4364 111 7546 7545 7547 -4365 111 7549 7548 7550 -4366 111 7552 7551 7553 -4367 111 7555 7554 7556 -4368 111 7558 7557 7559 -4369 111 7561 7560 7562 -4370 111 7564 7563 7565 -4371 111 7567 7566 7568 -4372 111 7570 7569 7571 -4373 111 7573 7572 7574 -4374 111 7576 7575 7577 -4375 111 7579 7578 7580 -4376 111 7582 7581 7583 -4377 111 7585 7584 7586 -4378 111 7588 7587 7589 -4379 111 7591 7590 7592 -4380 111 7594 7593 7595 -4381 111 7597 7596 7598 -4382 111 7600 7599 7601 -4383 111 7603 7602 7604 -4384 111 7606 7605 7607 -4385 111 7609 7608 7610 -4386 111 7612 7611 7613 -4387 111 7615 7614 7616 -4388 111 7618 7617 7619 -4389 111 7621 7620 7622 -4390 111 7624 7623 7625 -4391 111 7627 7626 7628 -4392 111 7630 7629 7631 -4393 111 7633 7632 7634 -4394 111 7636 7635 7637 -4395 111 7639 7638 7640 -4396 111 7642 7641 7643 -4397 111 7645 7644 7646 -4398 111 7648 7647 7649 -4399 111 7651 7650 7652 -4400 111 7654 7653 7655 -4401 111 7657 7656 7658 -4402 111 7660 7659 7661 -4403 111 7663 7662 7664 -4404 111 7666 7665 7667 -4405 111 7669 7668 7670 -4406 111 7672 7671 7673 -4407 111 7675 7674 7676 -4408 111 7678 7677 7679 -4409 111 7681 7680 7682 -4410 111 7684 7683 7685 -4411 111 7687 7686 7688 -4412 111 7690 7689 7691 -4413 111 7693 7692 7694 -4414 111 7696 7695 7697 -4415 111 7699 7698 7700 -4416 111 7702 7701 7703 -4417 111 7705 7704 7706 -4418 111 7708 7707 7709 -4419 111 7711 7710 7712 -4420 111 7714 7713 7715 -4421 111 7717 7716 7718 -4422 111 7720 7719 7721 -4423 111 7723 7722 7724 -4424 111 7726 7725 7727 -4425 111 7729 7728 7730 -4426 111 7732 7731 7733 -4427 111 7735 7734 7736 -4428 111 7738 7737 7739 -4429 111 7741 7740 7742 -4430 111 7744 7743 7745 -4431 111 7747 7746 7748 -4432 111 7750 7749 7751 -4433 111 7753 7752 7754 -4434 111 7756 7755 7757 -4435 111 7759 7758 7760 -4436 111 7762 7761 7763 -4437 111 7765 7764 7766 -4438 111 7768 7767 7769 -4439 111 7771 7770 7772 -4440 111 7774 7773 7775 -4441 111 7777 7776 7778 -4442 111 7780 7779 7781 -4443 111 7783 7782 7784 -4444 111 7786 7785 7787 -4445 111 7789 7788 7790 -4446 111 7792 7791 7793 -4447 111 7795 7794 7796 -4448 111 7798 7797 7799 -4449 111 7801 7800 7802 -4450 111 7804 7803 7805 -4451 111 7807 7806 7808 -4452 111 7810 7809 7811 -4453 111 7813 7812 7814 -4454 111 7816 7815 7817 -4455 111 7819 7818 7820 -4456 111 7822 7821 7823 -4457 111 7825 7824 7826 -4458 111 7828 7827 7829 -4459 111 7831 7830 7832 -4460 111 7834 7833 7835 -4461 111 7837 7836 7838 -4462 111 7840 7839 7841 -4463 111 7843 7842 7844 -4464 111 7846 7845 7847 -4465 111 7849 7848 7850 -4466 111 7852 7851 7853 -4467 111 7855 7854 7856 -4468 111 7858 7857 7859 -4469 111 7861 7860 7862 -4470 111 7864 7863 7865 -4471 111 7867 7866 7868 -4472 111 7870 7869 7871 -4473 111 7873 7872 7874 -4474 111 7876 7875 7877 -4475 111 7879 7878 7880 -4476 111 7882 7881 7883 -4477 111 7885 7884 7886 -4478 111 7888 7887 7889 -4479 111 7891 7890 7892 -4480 111 7894 7893 7895 -4481 111 7897 7896 7898 -4482 111 7900 7899 7901 -4483 111 7903 7902 7904 -4484 111 7906 7905 7907 -4485 111 7909 7908 7910 -4486 111 7912 7911 7913 -4487 111 7915 7914 7916 -4488 111 7918 7917 7919 -4489 111 7921 7920 7922 -4490 111 7924 7923 7925 -4491 111 7927 7926 7928 -4492 111 7930 7929 7931 -4493 111 7933 7932 7934 -4494 111 7936 7935 7937 -4495 111 7939 7938 7940 -4496 111 7942 7941 7943 -4497 111 7945 7944 7946 -4498 111 7948 7947 7949 -4499 111 7951 7950 7952 -4500 111 7954 7953 7955 -4501 111 7957 7956 7958 -4502 111 7960 7959 7961 -4503 111 7963 7962 7964 -4504 111 7966 7965 7967 -4505 111 7969 7968 7970 -4506 111 7972 7971 7973 -4507 111 7975 7974 7976 -4508 111 7978 7977 7979 -4509 111 7981 7980 7982 -4510 111 7984 7983 7985 -4511 111 7987 7986 7988 -4512 111 7990 7989 7991 -4513 111 7993 7992 7994 -4514 111 7996 7995 7997 -4515 111 7999 7998 8000 -4516 111 8002 8001 8003 -4517 111 8005 8004 8006 -4518 111 8008 8007 8009 -4519 111 8011 8010 8012 -4520 111 8014 8013 8015 -4521 111 8017 8016 8018 -4522 111 8020 8019 8021 -4523 111 8023 8022 8024 -4524 111 8026 8025 8027 -4525 111 8029 8028 8030 -4526 111 8032 8031 8033 -4527 111 8035 8034 8036 -4528 111 8038 8037 8039 -4529 111 8041 8040 8042 -4530 111 8044 8043 8045 -4531 111 8047 8046 8048 -4532 111 8050 8049 8051 -4533 111 8053 8052 8054 -4534 111 8056 8055 8057 -4535 111 8059 8058 8060 -4536 111 8062 8061 8063 -4537 111 8065 8064 8066 -4538 111 8068 8067 8069 -4539 111 8071 8070 8072 -4540 111 8074 8073 8075 -4541 111 8077 8076 8078 -4542 111 8080 8079 8081 -4543 111 8083 8082 8084 -4544 111 8086 8085 8087 -4545 111 8089 8088 8090 -4546 111 8092 8091 8093 -4547 111 8095 8094 8096 -4548 111 8098 8097 8099 -4549 111 8101 8100 8102 -4550 111 8104 8103 8105 -4551 111 8107 8106 8108 -4552 111 8110 8109 8111 -4553 111 8113 8112 8114 -4554 111 8116 8115 8117 -4555 111 8119 8118 8120 -4556 111 8122 8121 8123 -4557 111 8125 8124 8126 -4558 111 8128 8127 8129 -4559 111 8131 8130 8132 -4560 111 8134 8133 8135 -4561 111 8137 8136 8138 -4562 111 8140 8139 8141 -4563 111 8143 8142 8144 -4564 111 8146 8145 8147 -4565 111 8149 8148 8150 -4566 111 8152 8151 8153 -4567 111 8155 8154 8156 -4568 111 8158 8157 8159 -4569 111 8161 8160 8162 -4570 111 8164 8163 8165 -4571 111 8167 8166 8168 -4572 111 8170 8169 8171 -4573 111 8173 8172 8174 -4574 111 8176 8175 8177 -4575 111 8179 8178 8180 -4576 111 8182 8181 8183 -4577 111 8185 8184 8186 -4578 111 8188 8187 8189 -4579 111 8191 8190 8192 -4580 111 8194 8193 8195 -4581 111 8197 8196 8198 -4582 111 8200 8199 8201 -4583 111 8203 8202 8204 -4584 111 8206 8205 8207 -4585 111 8209 8208 8210 -4586 111 8212 8211 8213 -4587 111 8215 8214 8216 -4588 111 8218 8217 8219 -4589 111 8221 8220 8222 -4590 111 8224 8223 8225 -4591 111 8227 8226 8228 -4592 111 8230 8229 8231 -4593 111 8233 8232 8234 -4594 111 8236 8235 8237 -4595 111 8239 8238 8240 -4596 111 8242 8241 8243 -4597 111 8245 8244 8246 -4598 111 8248 8247 8249 -4599 111 8251 8250 8252 -4600 111 8254 8253 8255 -4601 111 8257 8256 8258 -4602 111 8260 8259 8261 -4603 111 8263 8262 8264 -4604 111 8266 8265 8267 -4605 111 8269 8268 8270 -4606 111 8272 8271 8273 -4607 111 8275 8274 8276 -4608 111 8278 8277 8279 -4609 111 8281 8280 8282 -4610 111 8284 8283 8285 -4611 111 8287 8286 8288 -4612 111 8290 8289 8291 -4613 111 8293 8292 8294 -4614 111 8296 8295 8297 -4615 111 8299 8298 8300 -4616 111 8302 8301 8303 -4617 111 8305 8304 8306 -4618 111 8308 8307 8309 -4619 111 8311 8310 8312 -4620 111 8314 8313 8315 -4621 111 8317 8316 8318 -4622 111 8320 8319 8321 -4623 111 8323 8322 8324 -4624 111 8326 8325 8327 -4625 111 8329 8328 8330 -4626 111 8332 8331 8333 -4627 111 8335 8334 8336 -4628 111 8338 8337 8339 -4629 111 8341 8340 8342 -4630 111 8344 8343 8345 -4631 111 8347 8346 8348 -4632 111 8350 8349 8351 -4633 111 8353 8352 8354 -4634 111 8356 8355 8357 -4635 111 8359 8358 8360 -4636 111 8362 8361 8363 -4637 111 8365 8364 8366 -4638 111 8368 8367 8369 -4639 111 8371 8370 8372 -4640 111 8374 8373 8375 -4641 111 8377 8376 8378 -4642 111 8380 8379 8381 -4643 111 8383 8382 8384 -4644 111 8386 8385 8387 -4645 111 8389 8388 8390 -4646 111 8392 8391 8393 -4647 111 8395 8394 8396 -4648 111 8398 8397 8399 -4649 111 8401 8400 8402 -4650 111 8404 8403 8405 -4651 111 8407 8406 8408 -4652 111 8410 8409 8411 -4653 111 8413 8412 8414 -4654 111 8416 8415 8417 -4655 111 8419 8418 8420 -4656 111 8422 8421 8423 -4657 111 8425 8424 8426 -4658 111 8428 8427 8429 -4659 111 8431 8430 8432 -4660 111 8434 8433 8435 -4661 111 8437 8436 8438 -4662 111 8440 8439 8441 -4663 111 8443 8442 8444 -4664 111 8446 8445 8447 -4665 111 8449 8448 8450 -4666 111 8452 8451 8453 -4667 111 8455 8454 8456 -4668 111 8458 8457 8459 -4669 111 8461 8460 8462 -4670 111 8464 8463 8465 -4671 111 8467 8466 8468 -4672 111 8470 8469 8471 -4673 111 8473 8472 8474 -4674 111 8476 8475 8477 -4675 111 8479 8478 8480 -4676 111 8482 8481 8483 -4677 111 8485 8484 8486 -4678 111 8488 8487 8489 -4679 111 8491 8490 8492 -4680 111 8494 8493 8495 -4681 111 8497 8496 8498 -4682 111 8500 8499 8501 -4683 111 8503 8502 8504 -4684 111 8506 8505 8507 -4685 111 8509 8508 8510 -4686 111 8512 8511 8513 -4687 111 8515 8514 8516 -4688 111 8518 8517 8519 -4689 111 8521 8520 8522 -4690 111 8524 8523 8525 -4691 111 8527 8526 8528 -4692 111 8530 8529 8531 -4693 111 8533 8532 8534 -4694 111 8536 8535 8537 -4695 111 8539 8538 8540 -4696 111 8542 8541 8543 -4697 111 8545 8544 8546 -4698 111 8548 8547 8549 -4699 111 8551 8550 8552 -4700 111 8554 8553 8555 -4701 111 8557 8556 8558 -4702 111 8560 8559 8561 -4703 111 8563 8562 8564 -4704 111 8566 8565 8567 -4705 111 8569 8568 8570 -4706 111 8572 8571 8573 -4707 111 8575 8574 8576 -4708 111 8578 8577 8579 -4709 111 8581 8580 8582 -4710 111 8584 8583 8585 -4711 111 8587 8586 8588 -4712 111 8590 8589 8591 -4713 111 8593 8592 8594 -4714 111 8596 8595 8597 -4715 111 8599 8598 8600 -4716 111 8602 8601 8603 -4717 111 8605 8604 8606 -4718 111 8608 8607 8609 -4719 111 8611 8610 8612 -4720 111 8614 8613 8615 -4721 111 8617 8616 8618 -4722 111 8620 8619 8621 -4723 111 8623 8622 8624 -4724 111 8626 8625 8627 -4725 111 8629 8628 8630 -4726 111 8632 8631 8633 -4727 111 8635 8634 8636 -4728 111 8638 8637 8639 -4729 111 8641 8640 8642 -4730 111 8644 8643 8645 -4731 111 8647 8646 8648 -4732 111 8650 8649 8651 -4733 111 8653 8652 8654 -4734 111 8656 8655 8657 -4735 111 8659 8658 8660 -4736 111 8662 8661 8663 -4737 111 8665 8664 8666 -4738 111 8668 8667 8669 -4739 111 8671 8670 8672 -4740 111 8674 8673 8675 -4741 111 8677 8676 8678 -4742 111 8680 8679 8681 -4743 111 8683 8682 8684 -4744 111 8686 8685 8687 -4745 111 8689 8688 8690 -4746 111 8692 8691 8693 -4747 111 8695 8694 8696 -4748 111 8698 8697 8699 -4749 111 8701 8700 8702 -4750 111 8704 8703 8705 -4751 111 8707 8706 8708 -4752 111 8710 8709 8711 -4753 111 8713 8712 8714 -4754 111 8716 8715 8717 -4755 111 8719 8718 8720 -4756 111 8722 8721 8723 -4757 111 8725 8724 8726 -4758 111 8728 8727 8729 -4759 111 8731 8730 8732 -4760 111 8734 8733 8735 -4761 111 8737 8736 8738 -4762 111 8740 8739 8741 -4763 111 8743 8742 8744 -4764 111 8746 8745 8747 -4765 111 8749 8748 8750 -4766 111 8752 8751 8753 -4767 111 8755 8754 8756 -4768 111 8758 8757 8759 -4769 111 8761 8760 8762 -4770 111 8764 8763 8765 -4771 111 8767 8766 8768 -4772 111 8770 8769 8771 -4773 111 8773 8772 8774 -4774 111 8776 8775 8777 -4775 111 8779 8778 8780 -4776 111 8782 8781 8783 -4777 111 8785 8784 8786 -4778 111 8788 8787 8789 -4779 111 8791 8790 8792 -4780 111 8794 8793 8795 -4781 111 8797 8796 8798 -4782 111 8800 8799 8801 -4783 111 8803 8802 8804 -4784 111 8806 8805 8807 -4785 111 8809 8808 8810 -4786 111 8812 8811 8813 -4787 111 8815 8814 8816 -4788 111 8818 8817 8819 -4789 111 8821 8820 8822 -4790 111 8824 8823 8825 -4791 111 8827 8826 8828 -4792 111 8830 8829 8831 -4793 111 8833 8832 8834 -4794 111 8836 8835 8837 -4795 111 8839 8838 8840 -4796 111 8842 8841 8843 -4797 111 8845 8844 8846 -4798 111 8848 8847 8849 -4799 111 8851 8850 8852 -4800 111 8854 8853 8855 -4801 111 8857 8856 8858 -4802 111 8860 8859 8861 -4803 111 8863 8862 8864 -4804 111 8866 8865 8867 -4805 111 8869 8868 8870 -4806 111 8872 8871 8873 -4807 111 8875 8874 8876 -4808 111 8878 8877 8879 -4809 111 8881 8880 8882 -4810 111 8884 8883 8885 -4811 111 8887 8886 8888 -4812 111 8890 8889 8891 -4813 111 8893 8892 8894 -4814 111 8896 8895 8897 -4815 111 8899 8898 8900 -4816 111 8902 8901 8903 -4817 111 8905 8904 8906 -4818 111 8908 8907 8909 -4819 111 8911 8910 8912 -4820 111 8914 8913 8915 -4821 111 8917 8916 8918 -4822 111 8920 8919 8921 -4823 111 8923 8922 8924 -4824 111 8926 8925 8927 -4825 111 8929 8928 8930 -4826 111 8932 8931 8933 -4827 111 8935 8934 8936 -4828 111 8938 8937 8939 -4829 111 8941 8940 8942 -4830 111 8944 8943 8945 -4831 111 8947 8946 8948 -4832 111 8950 8949 8951 -4833 111 8953 8952 8954 -4834 111 8956 8955 8957 -4835 111 8959 8958 8960 -4836 111 8962 8961 8963 -4837 111 8965 8964 8966 -4838 111 8968 8967 8969 -4839 111 8971 8970 8972 -4840 111 8974 8973 8975 -4841 111 8977 8976 8978 -4842 111 8980 8979 8981 -4843 111 8983 8982 8984 -4844 111 8986 8985 8987 -4845 111 8989 8988 8990 -4846 111 8992 8991 8993 -4847 111 8995 8994 8996 -4848 111 8998 8997 8999 -4849 111 9001 9000 9002 -4850 111 9004 9003 9005 -4851 111 9007 9006 9008 -4852 111 9010 9009 9011 -4853 111 9013 9012 9014 -4854 111 9016 9015 9017 -4855 111 9019 9018 9020 -4856 111 9022 9021 9023 -4857 111 9025 9024 9026 -4858 111 9028 9027 9029 -4859 111 9031 9030 9032 -4860 111 9034 9033 9035 -4861 111 9037 9036 9038 -4862 111 9040 9039 9041 -4863 111 9043 9042 9044 -4864 111 9046 9045 9047 -4865 111 9049 9048 9050 -4866 111 9052 9051 9053 -4867 111 9055 9054 9056 -4868 111 9058 9057 9059 -4869 111 9061 9060 9062 -4870 111 9064 9063 9065 -4871 111 9067 9066 9068 -4872 111 9070 9069 9071 -4873 111 9073 9072 9074 -4874 111 9076 9075 9077 -4875 111 9079 9078 9080 -4876 111 9082 9081 9083 -4877 111 9085 9084 9086 -4878 111 9088 9087 9089 -4879 111 9091 9090 9092 -4880 111 9094 9093 9095 -4881 111 9097 9096 9098 -4882 111 9100 9099 9101 -4883 111 9103 9102 9104 -4884 111 9106 9105 9107 -4885 111 9109 9108 9110 -4886 111 9112 9111 9113 -4887 111 9115 9114 9116 -4888 111 9118 9117 9119 -4889 111 9121 9120 9122 -4890 111 9124 9123 9125 -4891 111 9127 9126 9128 -4892 111 9130 9129 9131 -4893 111 9133 9132 9134 -4894 111 9136 9135 9137 -4895 111 9139 9138 9140 -4896 111 9142 9141 9143 -4897 111 9145 9144 9146 -4898 111 9148 9147 9149 -4899 111 9151 9150 9152 -4900 111 9154 9153 9155 -4901 111 9157 9156 9158 -4902 111 9160 9159 9161 -4903 111 9163 9162 9164 -4904 111 9166 9165 9167 -4905 111 9169 9168 9170 -4906 111 9172 9171 9173 -4907 111 9175 9174 9176 -4908 111 9178 9177 9179 -4909 111 9181 9180 9182 -4910 111 9184 9183 9185 -4911 111 9187 9186 9188 -4912 111 9190 9189 9191 -4913 111 9193 9192 9194 -4914 111 9196 9195 9197 -4915 111 9199 9198 9200 -4916 111 9202 9201 9203 -4917 111 9205 9204 9206 -4918 111 9208 9207 9209 -4919 111 9211 9210 9212 -4920 111 9214 9213 9215 -4921 111 9217 9216 9218 -4922 111 9220 9219 9221 -4923 111 9223 9222 9224 -4924 111 9226 9225 9227 -4925 111 9229 9228 9230 -4926 111 9232 9231 9233 -4927 111 9235 9234 9236 -4928 111 9238 9237 9239 -4929 111 9241 9240 9242 -4930 111 9244 9243 9245 -4931 111 9247 9246 9248 -4932 111 9250 9249 9251 -4933 111 9253 9252 9254 -4934 111 9256 9255 9257 -4935 111 9259 9258 9260 -4936 111 9262 9261 9263 -4937 111 9265 9264 9266 -4938 111 9268 9267 9269 -4939 111 9271 9270 9272 -4940 111 9274 9273 9275 -4941 111 9277 9276 9278 -4942 111 9280 9279 9281 -4943 111 9283 9282 9284 -4944 111 9286 9285 9287 -4945 111 9289 9288 9290 -4946 111 9292 9291 9293 -4947 111 9295 9294 9296 -4948 111 9298 9297 9299 -4949 111 9301 9300 9302 -4950 111 9304 9303 9305 -4951 111 9307 9306 9308 -4952 111 9310 9309 9311 -4953 111 9313 9312 9314 -4954 111 9316 9315 9317 -4955 111 9319 9318 9320 -4956 111 9322 9321 9323 -4957 111 9325 9324 9326 -4958 111 9328 9327 9329 -4959 111 9331 9330 9332 -4960 111 9334 9333 9335 -4961 111 9337 9336 9338 -4962 111 9340 9339 9341 -4963 111 9343 9342 9344 -4964 111 9346 9345 9347 -4965 111 9349 9348 9350 -4966 111 9352 9351 9353 -4967 111 9355 9354 9356 -4968 111 9358 9357 9359 -4969 111 9361 9360 9362 -4970 111 9364 9363 9365 -4971 111 9367 9366 9368 -4972 111 9370 9369 9371 -4973 111 9373 9372 9374 -4974 111 9376 9375 9377 -4975 111 9379 9378 9380 -4976 111 9382 9381 9383 -4977 111 9385 9384 9386 -4978 111 9388 9387 9389 -4979 111 9391 9390 9392 -4980 111 9394 9393 9395 -4981 111 9397 9396 9398 -4982 111 9400 9399 9401 -4983 111 9403 9402 9404 -4984 111 9406 9405 9407 -4985 111 9409 9408 9410 -4986 111 9412 9411 9413 -4987 111 9415 9414 9416 -4988 111 9418 9417 9419 -4989 111 9421 9420 9422 -4990 111 9424 9423 9425 -4991 111 9427 9426 9428 -4992 111 9430 9429 9431 -4993 111 9433 9432 9434 -4994 111 9436 9435 9437 -4995 111 9439 9438 9440 -4996 111 9442 9441 9443 -4997 111 9445 9444 9446 -4998 111 9448 9447 9449 -4999 111 9451 9450 9452 -5000 111 9454 9453 9455 -5001 111 9457 9456 9458 -5002 111 9460 9459 9461 -5003 111 9463 9462 9464 -5004 111 9466 9465 9467 -5005 111 9469 9468 9470 -5006 111 9472 9471 9473 -5007 111 9475 9474 9476 -5008 111 9478 9477 9479 -5009 111 9481 9480 9482 -5010 111 9484 9483 9485 -5011 111 9487 9486 9488 -5012 111 9490 9489 9491 -5013 111 9493 9492 9494 -5014 111 9496 9495 9497 -5015 111 9499 9498 9500 -5016 111 9502 9501 9503 -5017 111 9505 9504 9506 -5018 111 9508 9507 9509 -5019 111 9511 9510 9512 -5020 111 9514 9513 9515 -5021 111 9517 9516 9518 -5022 111 9520 9519 9521 -5023 111 9523 9522 9524 -5024 111 9526 9525 9527 -5025 111 9529 9528 9530 -5026 111 9532 9531 9533 -5027 111 9535 9534 9536 -5028 111 9538 9537 9539 -5029 111 9541 9540 9542 -5030 111 9544 9543 9545 -5031 111 9547 9546 9548 -5032 111 9550 9549 9551 -5033 111 9553 9552 9554 -5034 111 9556 9555 9557 -5035 111 9559 9558 9560 -5036 111 9562 9561 9563 -5037 111 9565 9564 9566 -5038 111 9568 9567 9569 -5039 111 9571 9570 9572 -5040 111 9574 9573 9575 -5041 111 9577 9576 9578 -5042 111 9580 9579 9581 -5043 111 9583 9582 9584 -5044 111 9586 9585 9587 -5045 111 9589 9588 9590 -5046 111 9592 9591 9593 -5047 111 9595 9594 9596 -5048 111 9598 9597 9599 -5049 111 9601 9600 9602 -5050 111 9604 9603 9605 -5051 111 9607 9606 9608 -5052 111 9610 9609 9611 -5053 111 9613 9612 9614 -5054 111 9616 9615 9617 -5055 111 9619 9618 9620 -5056 111 9622 9621 9623 -5057 111 9625 9624 9626 -5058 111 9628 9627 9629 -5059 111 9631 9630 9632 -5060 111 9634 9633 9635 -5061 111 9637 9636 9638 -5062 111 9640 9639 9641 -5063 111 9643 9642 9644 -5064 111 9646 9645 9647 -5065 111 9649 9648 9650 -5066 111 9652 9651 9653 -5067 111 9655 9654 9656 -5068 111 9658 9657 9659 -5069 111 9661 9660 9662 -5070 111 9664 9663 9665 -5071 111 9667 9666 9668 -5072 111 9670 9669 9671 -5073 111 9673 9672 9674 -5074 111 9676 9675 9677 -5075 111 9679 9678 9680 -5076 111 9682 9681 9683 -5077 111 9685 9684 9686 -5078 111 9688 9687 9689 -5079 111 9691 9690 9692 -5080 111 9694 9693 9695 -5081 111 9697 9696 9698 -5082 111 9700 9699 9701 -5083 111 9703 9702 9704 -5084 111 9706 9705 9707 -5085 111 9709 9708 9710 -5086 111 9712 9711 9713 -5087 111 9715 9714 9716 -5088 111 9718 9717 9719 -5089 111 9721 9720 9722 -5090 111 9724 9723 9725 -5091 111 9727 9726 9728 -5092 111 9730 9729 9731 -5093 111 9733 9732 9734 -5094 111 9736 9735 9737 +2259 62 1232 1227 1228 +2260 111 1235 1233 1234 +2261 111 1238 1236 1237 +2262 111 1241 1239 1240 +2263 111 1244 1242 1243 +2264 111 1247 1245 1246 +2265 111 1250 1248 1249 +2266 111 1253 1251 1252 +2267 111 1256 1254 1255 +2268 111 1259 1257 1258 +2269 111 1262 1260 1261 +2270 111 1265 1263 1264 +2271 111 1268 1266 1267 +2272 111 1271 1269 1270 +2273 111 1274 1272 1273 +2274 111 1277 1275 1276 +2275 111 1280 1278 1279 +2276 111 1283 1281 1282 +2277 111 1286 1284 1285 +2278 111 1289 1287 1288 +2279 111 1292 1290 1291 +2280 111 1295 1293 1294 +2281 111 1298 1296 1297 +2282 111 1301 1299 1300 +2283 111 1304 1302 1303 +2284 111 1307 1305 1306 +2285 111 1310 1308 1309 +2286 111 1313 1311 1312 +2287 111 1316 1314 1315 +2288 111 1319 1317 1318 +2289 111 1322 1320 1321 +2290 111 1325 1323 1324 +2291 111 1328 1326 1327 +2292 111 1331 1329 1330 +2293 111 1334 1332 1333 +2294 111 1337 1335 1336 +2295 111 1340 1338 1339 +2296 111 1343 1341 1342 +2297 111 1346 1344 1345 +2298 111 1349 1347 1348 +2299 111 1352 1350 1351 +2300 111 1355 1353 1354 +2301 111 1358 1356 1357 +2302 111 1361 1359 1360 +2303 111 1364 1362 1363 +2304 111 1367 1365 1366 +2305 111 1370 1368 1369 +2306 111 1373 1371 1372 +2307 111 1376 1374 1375 +2308 111 1379 1377 1378 +2309 111 1382 1380 1381 +2310 111 1385 1383 1384 +2311 111 1388 1386 1387 +2312 111 1391 1389 1390 +2313 111 1394 1392 1393 +2314 111 1397 1395 1396 +2315 111 1400 1398 1399 +2316 111 1403 1401 1402 +2317 111 1406 1404 1405 +2318 111 1409 1407 1408 +2319 111 1412 1410 1411 +2320 111 1415 1413 1414 +2321 111 1418 1416 1417 +2322 111 1421 1419 1420 +2323 111 1424 1422 1423 +2324 111 1427 1425 1426 +2325 111 1430 1428 1429 +2326 111 1433 1431 1432 +2327 111 1436 1434 1435 +2328 111 1439 1437 1438 +2329 111 1442 1440 1441 +2330 111 1445 1443 1444 +2331 111 1448 1446 1447 +2332 111 1451 1449 1450 +2333 111 1454 1452 1453 +2334 111 1457 1455 1456 +2335 111 1460 1458 1459 +2336 111 1463 1461 1462 +2337 111 1466 1464 1465 +2338 111 1469 1467 1468 +2339 111 1472 1470 1471 +2340 111 1475 1473 1474 +2341 111 1478 1476 1477 +2342 111 1481 1479 1480 +2343 111 1484 1482 1483 +2344 111 1487 1485 1486 +2345 111 1490 1488 1489 +2346 111 1493 1491 1492 +2347 111 1496 1494 1495 +2348 111 1499 1497 1498 +2349 111 1502 1500 1501 +2350 111 1505 1503 1504 +2351 111 1508 1506 1507 +2352 111 1511 1509 1510 +2353 111 1514 1512 1513 +2354 111 1517 1515 1516 +2355 111 1520 1518 1519 +2356 111 1523 1521 1522 +2357 111 1526 1524 1525 +2358 111 1529 1527 1528 +2359 111 1532 1530 1531 +2360 111 1535 1533 1534 +2361 111 1538 1536 1537 +2362 111 1541 1539 1540 +2363 111 1544 1542 1543 +2364 111 1547 1545 1546 +2365 111 1550 1548 1549 +2366 111 1553 1551 1552 +2367 111 1556 1554 1555 +2368 111 1559 1557 1558 +2369 111 1562 1560 1561 +2370 111 1565 1563 1564 +2371 111 1568 1566 1567 +2372 111 1571 1569 1570 +2373 111 1574 1572 1573 +2374 111 1577 1575 1576 +2375 111 1580 1578 1579 +2376 111 1583 1581 1582 +2377 111 1586 1584 1585 +2378 111 1589 1587 1588 +2379 111 1592 1590 1591 +2380 111 1595 1593 1594 +2381 111 1598 1596 1597 +2382 111 1601 1599 1600 +2383 111 1604 1602 1603 +2384 111 1607 1605 1606 +2385 111 1610 1608 1609 +2386 111 1613 1611 1612 +2387 111 1616 1614 1615 +2388 111 1619 1617 1618 +2389 111 1622 1620 1621 +2390 111 1625 1623 1624 +2391 111 1628 1626 1627 +2392 111 1631 1629 1630 +2393 111 1634 1632 1633 +2394 111 1637 1635 1636 +2395 111 1640 1638 1639 +2396 111 1643 1641 1642 +2397 111 1646 1644 1645 +2398 111 1649 1647 1648 +2399 111 1652 1650 1651 +2400 111 1655 1653 1654 +2401 111 1658 1656 1657 +2402 111 1661 1659 1660 +2403 111 1664 1662 1663 +2404 111 1667 1665 1666 +2405 111 1670 1668 1669 +2406 111 1673 1671 1672 +2407 111 1676 1674 1675 +2408 111 1679 1677 1678 +2409 111 1682 1680 1681 +2410 111 1685 1683 1684 +2411 111 1688 1686 1687 +2412 111 1691 1689 1690 +2413 111 1694 1692 1693 +2414 111 1697 1695 1696 +2415 111 1700 1698 1699 +2416 111 1703 1701 1702 +2417 111 1706 1704 1705 +2418 111 1709 1707 1708 +2419 111 1712 1710 1711 +2420 111 1715 1713 1714 +2421 111 1718 1716 1717 +2422 111 1721 1719 1720 +2423 111 1724 1722 1723 +2424 111 1727 1725 1726 +2425 111 1730 1728 1729 +2426 111 1733 1731 1732 +2427 111 1736 1734 1735 +2428 111 1739 1737 1738 +2429 111 1742 1740 1741 +2430 111 1745 1743 1744 +2431 111 1748 1746 1747 +2432 111 1751 1749 1750 +2433 111 1754 1752 1753 +2434 111 1757 1755 1756 +2435 111 1760 1758 1759 +2436 111 1763 1761 1762 +2437 111 1766 1764 1765 +2438 111 1769 1767 1768 +2439 111 1772 1770 1771 +2440 111 1775 1773 1774 +2441 111 1778 1776 1777 +2442 111 1781 1779 1780 +2443 111 1784 1782 1783 +2444 111 1787 1785 1786 +2445 111 1790 1788 1789 +2446 111 1793 1791 1792 +2447 111 1796 1794 1795 +2448 111 1799 1797 1798 +2449 111 1802 1800 1801 +2450 111 1805 1803 1804 +2451 111 1808 1806 1807 +2452 111 1811 1809 1810 +2453 111 1814 1812 1813 +2454 111 1817 1815 1816 +2455 111 1820 1818 1819 +2456 111 1823 1821 1822 +2457 111 1826 1824 1825 +2458 111 1829 1827 1828 +2459 111 1832 1830 1831 +2460 111 1835 1833 1834 +2461 111 1838 1836 1837 +2462 111 1841 1839 1840 +2463 111 1844 1842 1843 +2464 111 1847 1845 1846 +2465 111 1850 1848 1849 +2466 111 1853 1851 1852 +2467 111 1856 1854 1855 +2468 111 1859 1857 1858 +2469 111 1862 1860 1861 +2470 111 1865 1863 1864 +2471 111 1868 1866 1867 +2472 111 1871 1869 1870 +2473 111 1874 1872 1873 +2474 111 1877 1875 1876 +2475 111 1880 1878 1879 +2476 111 1883 1881 1882 +2477 111 1886 1884 1885 +2478 111 1889 1887 1888 +2479 111 1892 1890 1891 +2480 111 1895 1893 1894 +2481 111 1898 1896 1897 +2482 111 1901 1899 1900 +2483 111 1904 1902 1903 +2484 111 1907 1905 1906 +2485 111 1910 1908 1909 +2486 111 1913 1911 1912 +2487 111 1916 1914 1915 +2488 111 1919 1917 1918 +2489 111 1922 1920 1921 +2490 111 1925 1923 1924 +2491 111 1928 1926 1927 +2492 111 1931 1929 1930 +2493 111 1934 1932 1933 +2494 111 1937 1935 1936 +2495 111 1940 1938 1939 +2496 111 1943 1941 1942 +2497 111 1946 1944 1945 +2498 111 1949 1947 1948 +2499 111 1952 1950 1951 +2500 111 1955 1953 1954 +2501 111 1958 1956 1957 +2502 111 1961 1959 1960 +2503 111 1964 1962 1963 +2504 111 1967 1965 1966 +2505 111 1970 1968 1969 +2506 111 1973 1971 1972 +2507 111 1976 1974 1975 +2508 111 1979 1977 1978 +2509 111 1982 1980 1981 +2510 111 1985 1983 1984 +2511 111 1988 1986 1987 +2512 111 1991 1989 1990 +2513 111 1994 1992 1993 +2514 111 1997 1995 1996 +2515 111 2000 1998 1999 +2516 111 2003 2001 2002 +2517 111 2006 2004 2005 +2518 111 2009 2007 2008 +2519 111 2012 2010 2011 +2520 111 2015 2013 2014 +2521 111 2018 2016 2017 +2522 111 2021 2019 2020 +2523 111 2024 2022 2023 +2524 111 2027 2025 2026 +2525 111 2030 2028 2029 +2526 111 2033 2031 2032 +2527 111 2036 2034 2035 +2528 111 2039 2037 2038 +2529 111 2042 2040 2041 +2530 111 2045 2043 2044 +2531 111 2048 2046 2047 +2532 111 2051 2049 2050 +2533 111 2054 2052 2053 +2534 111 2057 2055 2056 +2535 111 2060 2058 2059 +2536 111 2063 2061 2062 +2537 111 2066 2064 2065 +2538 111 2069 2067 2068 +2539 111 2072 2070 2071 +2540 111 2075 2073 2074 +2541 111 2078 2076 2077 +2542 111 2081 2079 2080 +2543 111 2084 2082 2083 +2544 111 2087 2085 2086 +2545 111 2090 2088 2089 +2546 111 2093 2091 2092 +2547 111 2096 2094 2095 +2548 111 2099 2097 2098 +2549 111 2102 2100 2101 +2550 111 2105 2103 2104 +2551 111 2108 2106 2107 +2552 111 2111 2109 2110 +2553 111 2114 2112 2113 +2554 111 2117 2115 2116 +2555 111 2120 2118 2119 +2556 111 2123 2121 2122 +2557 111 2126 2124 2125 +2558 111 2129 2127 2128 +2559 111 2132 2130 2131 +2560 111 2135 2133 2134 +2561 111 2138 2136 2137 +2562 111 2141 2139 2140 +2563 111 2144 2142 2143 +2564 111 2147 2145 2146 +2565 111 2150 2148 2149 +2566 111 2153 2151 2152 +2567 111 2156 2154 2155 +2568 111 2159 2157 2158 +2569 111 2162 2160 2161 +2570 111 2165 2163 2164 +2571 111 2168 2166 2167 +2572 111 2171 2169 2170 +2573 111 2174 2172 2173 +2574 111 2177 2175 2176 +2575 111 2180 2178 2179 +2576 111 2183 2181 2182 +2577 111 2186 2184 2185 +2578 111 2189 2187 2188 +2579 111 2192 2190 2191 +2580 111 2195 2193 2194 +2581 111 2198 2196 2197 +2582 111 2201 2199 2200 +2583 111 2204 2202 2203 +2584 111 2207 2205 2206 +2585 111 2210 2208 2209 +2586 111 2213 2211 2212 +2587 111 2216 2214 2215 +2588 111 2219 2217 2218 +2589 111 2222 2220 2221 +2590 111 2225 2223 2224 +2591 111 2228 2226 2227 +2592 111 2231 2229 2230 +2593 111 2234 2232 2233 +2594 111 2237 2235 2236 +2595 111 2240 2238 2239 +2596 111 2243 2241 2242 +2597 111 2246 2244 2245 +2598 111 2249 2247 2248 +2599 111 2252 2250 2251 +2600 111 2255 2253 2254 +2601 111 2258 2256 2257 +2602 111 2261 2259 2260 +2603 111 2264 2262 2263 +2604 111 2267 2265 2266 +2605 111 2270 2268 2269 +2606 111 2273 2271 2272 +2607 111 2276 2274 2275 +2608 111 2279 2277 2278 +2609 111 2282 2280 2281 +2610 111 2285 2283 2284 +2611 111 2288 2286 2287 +2612 111 2291 2289 2290 +2613 111 2294 2292 2293 +2614 111 2297 2295 2296 +2615 111 2300 2298 2299 +2616 111 2303 2301 2302 +2617 111 2306 2304 2305 +2618 111 2309 2307 2308 +2619 111 2312 2310 2311 +2620 111 2315 2313 2314 +2621 111 2318 2316 2317 +2622 111 2321 2319 2320 +2623 111 2324 2322 2323 +2624 111 2327 2325 2326 +2625 111 2330 2328 2329 +2626 111 2333 2331 2332 +2627 111 2336 2334 2335 +2628 111 2339 2337 2338 +2629 111 2342 2340 2341 +2630 111 2345 2343 2344 +2631 111 2348 2346 2347 +2632 111 2351 2349 2350 +2633 111 2354 2352 2353 +2634 111 2357 2355 2356 +2635 111 2360 2358 2359 +2636 111 2363 2361 2362 +2637 111 2366 2364 2365 +2638 111 2369 2367 2368 +2639 111 2372 2370 2371 +2640 111 2375 2373 2374 +2641 111 2378 2376 2377 +2642 111 2381 2379 2380 +2643 111 2384 2382 2383 +2644 111 2387 2385 2386 +2645 111 2390 2388 2389 +2646 111 2393 2391 2392 +2647 111 2396 2394 2395 +2648 111 2399 2397 2398 +2649 111 2402 2400 2401 +2650 111 2405 2403 2404 +2651 111 2408 2406 2407 +2652 111 2411 2409 2410 +2653 111 2414 2412 2413 +2654 111 2417 2415 2416 +2655 111 2420 2418 2419 +2656 111 2423 2421 2422 +2657 111 2426 2424 2425 +2658 111 2429 2427 2428 +2659 111 2432 2430 2431 +2660 111 2435 2433 2434 +2661 111 2438 2436 2437 +2662 111 2441 2439 2440 +2663 111 2444 2442 2443 +2664 111 2447 2445 2446 +2665 111 2450 2448 2449 +2666 111 2453 2451 2452 +2667 111 2456 2454 2455 +2668 111 2459 2457 2458 +2669 111 2462 2460 2461 +2670 111 2465 2463 2464 +2671 111 2468 2466 2467 +2672 111 2471 2469 2470 +2673 111 2474 2472 2473 +2674 111 2477 2475 2476 +2675 111 2480 2478 2479 +2676 111 2483 2481 2482 +2677 111 2486 2484 2485 +2678 111 2489 2487 2488 +2679 111 2492 2490 2491 +2680 111 2495 2493 2494 +2681 111 2498 2496 2497 +2682 111 2501 2499 2500 +2683 111 2504 2502 2503 +2684 111 2507 2505 2506 +2685 111 2510 2508 2509 +2686 111 2513 2511 2512 +2687 111 2516 2514 2515 +2688 111 2519 2517 2518 +2689 111 2522 2520 2521 +2690 111 2525 2523 2524 +2691 111 2528 2526 2527 +2692 111 2531 2529 2530 +2693 111 2534 2532 2533 +2694 111 2537 2535 2536 +2695 111 2540 2538 2539 +2696 111 2543 2541 2542 +2697 111 2546 2544 2545 +2698 111 2549 2547 2548 +2699 111 2552 2550 2551 +2700 111 2555 2553 2554 +2701 111 2558 2556 2557 +2702 111 2561 2559 2560 +2703 111 2564 2562 2563 +2704 111 2567 2565 2566 +2705 111 2570 2568 2569 +2706 111 2573 2571 2572 +2707 111 2576 2574 2575 +2708 111 2579 2577 2578 +2709 111 2582 2580 2581 +2710 111 2585 2583 2584 +2711 111 2588 2586 2587 +2712 111 2591 2589 2590 +2713 111 2594 2592 2593 +2714 111 2597 2595 2596 +2715 111 2600 2598 2599 +2716 111 2603 2601 2602 +2717 111 2606 2604 2605 +2718 111 2609 2607 2608 +2719 111 2612 2610 2611 +2720 111 2615 2613 2614 +2721 111 2618 2616 2617 +2722 111 2621 2619 2620 +2723 111 2624 2622 2623 +2724 111 2627 2625 2626 +2725 111 2630 2628 2629 +2726 111 2633 2631 2632 +2727 111 2636 2634 2635 +2728 111 2639 2637 2638 +2729 111 2642 2640 2641 +2730 111 2645 2643 2644 +2731 111 2648 2646 2647 +2732 111 2651 2649 2650 +2733 111 2654 2652 2653 +2734 111 2657 2655 2656 +2735 111 2660 2658 2659 +2736 111 2663 2661 2662 +2737 111 2666 2664 2665 +2738 111 2669 2667 2668 +2739 111 2672 2670 2671 +2740 111 2675 2673 2674 +2741 111 2678 2676 2677 +2742 111 2681 2679 2680 +2743 111 2684 2682 2683 +2744 111 2687 2685 2686 +2745 111 2690 2688 2689 +2746 111 2693 2691 2692 +2747 111 2696 2694 2695 +2748 111 2699 2697 2698 +2749 111 2702 2700 2701 +2750 111 2705 2703 2704 +2751 111 2708 2706 2707 +2752 111 2711 2709 2710 +2753 111 2714 2712 2713 +2754 111 2717 2715 2716 +2755 111 2720 2718 2719 +2756 111 2723 2721 2722 +2757 111 2726 2724 2725 +2758 111 2729 2727 2728 +2759 111 2732 2730 2731 +2760 111 2735 2733 2734 +2761 111 2738 2736 2737 +2762 111 2741 2739 2740 +2763 111 2744 2742 2743 +2764 111 2747 2745 2746 +2765 111 2750 2748 2749 +2766 111 2753 2751 2752 +2767 111 2756 2754 2755 +2768 111 2759 2757 2758 +2769 111 2762 2760 2761 +2770 111 2765 2763 2764 +2771 111 2768 2766 2767 +2772 111 2771 2769 2770 +2773 111 2774 2772 2773 +2774 111 2777 2775 2776 +2775 111 2780 2778 2779 +2776 111 2783 2781 2782 +2777 111 2786 2784 2785 +2778 111 2789 2787 2788 +2779 111 2792 2790 2791 +2780 111 2795 2793 2794 +2781 111 2798 2796 2797 +2782 111 2801 2799 2800 +2783 111 2804 2802 2803 +2784 111 2807 2805 2806 +2785 111 2810 2808 2809 +2786 111 2813 2811 2812 +2787 111 2816 2814 2815 +2788 111 2819 2817 2818 +2789 111 2822 2820 2821 +2790 111 2825 2823 2824 +2791 111 2828 2826 2827 +2792 111 2831 2829 2830 +2793 111 2834 2832 2833 +2794 111 2837 2835 2836 +2795 111 2840 2838 2839 +2796 111 2843 2841 2842 +2797 111 2846 2844 2845 +2798 111 2849 2847 2848 +2799 111 2852 2850 2851 +2800 111 2855 2853 2854 +2801 111 2858 2856 2857 +2802 111 2861 2859 2860 +2803 111 2864 2862 2863 +2804 111 2867 2865 2866 +2805 111 2870 2868 2869 +2806 111 2873 2871 2872 +2807 111 2876 2874 2875 +2808 111 2879 2877 2878 +2809 111 2882 2880 2881 +2810 111 2885 2883 2884 +2811 111 2888 2886 2887 +2812 111 2891 2889 2890 +2813 111 2894 2892 2893 +2814 111 2897 2895 2896 +2815 111 2900 2898 2899 +2816 111 2903 2901 2902 +2817 111 2906 2904 2905 +2818 111 2909 2907 2908 +2819 111 2912 2910 2911 +2820 111 2915 2913 2914 +2821 111 2918 2916 2917 +2822 111 2921 2919 2920 +2823 111 2924 2922 2923 +2824 111 2927 2925 2926 +2825 111 2930 2928 2929 +2826 111 2933 2931 2932 +2827 111 2936 2934 2935 +2828 111 2939 2937 2938 +2829 111 2942 2940 2941 +2830 111 2945 2943 2944 +2831 111 2948 2946 2947 +2832 111 2951 2949 2950 +2833 111 2954 2952 2953 +2834 111 2957 2955 2956 +2835 111 2960 2958 2959 +2836 111 2963 2961 2962 +2837 111 2966 2964 2965 +2838 111 2969 2967 2968 +2839 111 2972 2970 2971 +2840 111 2975 2973 2974 +2841 111 2978 2976 2977 +2842 111 2981 2979 2980 +2843 111 2984 2982 2983 +2844 111 2987 2985 2986 +2845 111 2990 2988 2989 +2846 111 2993 2991 2992 +2847 111 2996 2994 2995 +2848 111 2999 2997 2998 +2849 111 3002 3000 3001 +2850 111 3005 3003 3004 +2851 111 3008 3006 3007 +2852 111 3011 3009 3010 +2853 111 3014 3012 3013 +2854 111 3017 3015 3016 +2855 111 3020 3018 3019 +2856 111 3023 3021 3022 +2857 111 3026 3024 3025 +2858 111 3029 3027 3028 +2859 111 3032 3030 3031 +2860 111 3035 3033 3034 +2861 111 3038 3036 3037 +2862 111 3041 3039 3040 +2863 111 3044 3042 3043 +2864 111 3047 3045 3046 +2865 111 3050 3048 3049 +2866 111 3053 3051 3052 +2867 111 3056 3054 3055 +2868 111 3059 3057 3058 +2869 111 3062 3060 3061 +2870 111 3065 3063 3064 +2871 111 3068 3066 3067 +2872 111 3071 3069 3070 +2873 111 3074 3072 3073 +2874 111 3077 3075 3076 +2875 111 3080 3078 3079 +2876 111 3083 3081 3082 +2877 111 3086 3084 3085 +2878 111 3089 3087 3088 +2879 111 3092 3090 3091 +2880 111 3095 3093 3094 +2881 111 3098 3096 3097 +2882 111 3101 3099 3100 +2883 111 3104 3102 3103 +2884 111 3107 3105 3106 +2885 111 3110 3108 3109 +2886 111 3113 3111 3112 +2887 111 3116 3114 3115 +2888 111 3119 3117 3118 +2889 111 3122 3120 3121 +2890 111 3125 3123 3124 +2891 111 3128 3126 3127 +2892 111 3131 3129 3130 +2893 111 3134 3132 3133 +2894 111 3137 3135 3136 +2895 111 3140 3138 3139 +2896 111 3143 3141 3142 +2897 111 3146 3144 3145 +2898 111 3149 3147 3148 +2899 111 3152 3150 3151 +2900 111 3155 3153 3154 +2901 111 3158 3156 3157 +2902 111 3161 3159 3160 +2903 111 3164 3162 3163 +2904 111 3167 3165 3166 +2905 111 3170 3168 3169 +2906 111 3173 3171 3172 +2907 111 3176 3174 3175 +2908 111 3179 3177 3178 +2909 111 3182 3180 3181 +2910 111 3185 3183 3184 +2911 111 3188 3186 3187 +2912 111 3191 3189 3190 +2913 111 3194 3192 3193 +2914 111 3197 3195 3196 +2915 111 3200 3198 3199 +2916 111 3203 3201 3202 +2917 111 3206 3204 3205 +2918 111 3209 3207 3208 +2919 111 3212 3210 3211 +2920 111 3215 3213 3214 +2921 111 3218 3216 3217 +2922 111 3221 3219 3220 +2923 111 3224 3222 3223 +2924 111 3227 3225 3226 +2925 111 3230 3228 3229 +2926 111 3233 3231 3232 +2927 111 3236 3234 3235 +2928 111 3239 3237 3238 +2929 111 3242 3240 3241 +2930 111 3245 3243 3244 +2931 111 3248 3246 3247 +2932 111 3251 3249 3250 +2933 111 3254 3252 3253 +2934 111 3257 3255 3256 +2935 111 3260 3258 3259 +2936 111 3263 3261 3262 +2937 111 3266 3264 3265 +2938 111 3269 3267 3268 +2939 111 3272 3270 3271 +2940 111 3275 3273 3274 +2941 111 3278 3276 3277 +2942 111 3281 3279 3280 +2943 111 3284 3282 3283 +2944 111 3287 3285 3286 +2945 111 3290 3288 3289 +2946 111 3293 3291 3292 +2947 111 3296 3294 3295 +2948 111 3299 3297 3298 +2949 111 3302 3300 3301 +2950 111 3305 3303 3304 +2951 111 3308 3306 3307 +2952 111 3311 3309 3310 +2953 111 3314 3312 3313 +2954 111 3317 3315 3316 +2955 111 3320 3318 3319 +2956 111 3323 3321 3322 +2957 111 3326 3324 3325 +2958 111 3329 3327 3328 +2959 111 3332 3330 3331 +2960 111 3335 3333 3334 +2961 111 3338 3336 3337 +2962 111 3341 3339 3340 +2963 111 3344 3342 3343 +2964 111 3347 3345 3346 +2965 111 3350 3348 3349 +2966 111 3353 3351 3352 +2967 111 3356 3354 3355 +2968 111 3359 3357 3358 +2969 111 3362 3360 3361 +2970 111 3365 3363 3364 +2971 111 3368 3366 3367 +2972 111 3371 3369 3370 +2973 111 3374 3372 3373 +2974 111 3377 3375 3376 +2975 111 3380 3378 3379 +2976 111 3383 3381 3382 +2977 111 3386 3384 3385 +2978 111 3389 3387 3388 +2979 111 3392 3390 3391 +2980 111 3395 3393 3394 +2981 111 3398 3396 3397 +2982 111 3401 3399 3400 +2983 111 3404 3402 3403 +2984 111 3407 3405 3406 +2985 111 3410 3408 3409 +2986 111 3413 3411 3412 +2987 111 3416 3414 3415 +2988 111 3419 3417 3418 +2989 111 3422 3420 3421 +2990 111 3425 3423 3424 +2991 111 3428 3426 3427 +2992 111 3431 3429 3430 +2993 111 3434 3432 3433 +2994 111 3437 3435 3436 +2995 111 3440 3438 3439 +2996 111 3443 3441 3442 +2997 111 3446 3444 3445 +2998 111 3449 3447 3448 +2999 111 3452 3450 3451 +3000 111 3455 3453 3454 +3001 111 3458 3456 3457 +3002 111 3461 3459 3460 +3003 111 3464 3462 3463 +3004 111 3467 3465 3466 +3005 111 3470 3468 3469 +3006 111 3473 3471 3472 +3007 111 3476 3474 3475 +3008 111 3479 3477 3478 +3009 111 3482 3480 3481 +3010 111 3485 3483 3484 +3011 111 3488 3486 3487 +3012 111 3491 3489 3490 +3013 111 3494 3492 3493 +3014 111 3497 3495 3496 +3015 111 3500 3498 3499 +3016 111 3503 3501 3502 +3017 111 3506 3504 3505 +3018 111 3509 3507 3508 +3019 111 3512 3510 3511 +3020 111 3515 3513 3514 +3021 111 3518 3516 3517 +3022 111 3521 3519 3520 +3023 111 3524 3522 3523 +3024 111 3527 3525 3526 +3025 111 3530 3528 3529 +3026 111 3533 3531 3532 +3027 111 3536 3534 3535 +3028 111 3539 3537 3538 +3029 111 3542 3540 3541 +3030 111 3545 3543 3544 +3031 111 3548 3546 3547 +3032 111 3551 3549 3550 +3033 111 3554 3552 3553 +3034 111 3557 3555 3556 +3035 111 3560 3558 3559 +3036 111 3563 3561 3562 +3037 111 3566 3564 3565 +3038 111 3569 3567 3568 +3039 111 3572 3570 3571 +3040 111 3575 3573 3574 +3041 111 3578 3576 3577 +3042 111 3581 3579 3580 +3043 111 3584 3582 3583 +3044 111 3587 3585 3586 +3045 111 3590 3588 3589 +3046 111 3593 3591 3592 +3047 111 3596 3594 3595 +3048 111 3599 3597 3598 +3049 111 3602 3600 3601 +3050 111 3605 3603 3604 +3051 111 3608 3606 3607 +3052 111 3611 3609 3610 +3053 111 3614 3612 3613 +3054 111 3617 3615 3616 +3055 111 3620 3618 3619 +3056 111 3623 3621 3622 +3057 111 3626 3624 3625 +3058 111 3629 3627 3628 +3059 111 3632 3630 3631 +3060 111 3635 3633 3634 +3061 111 3638 3636 3637 +3062 111 3641 3639 3640 +3063 111 3644 3642 3643 +3064 111 3647 3645 3646 +3065 111 3650 3648 3649 +3066 111 3653 3651 3652 +3067 111 3656 3654 3655 +3068 111 3659 3657 3658 +3069 111 3662 3660 3661 +3070 111 3665 3663 3664 +3071 111 3668 3666 3667 +3072 111 3671 3669 3670 +3073 111 3674 3672 3673 +3074 111 3677 3675 3676 +3075 111 3680 3678 3679 +3076 111 3683 3681 3682 +3077 111 3686 3684 3685 +3078 111 3689 3687 3688 +3079 111 3692 3690 3691 +3080 111 3695 3693 3694 +3081 111 3698 3696 3697 +3082 111 3701 3699 3700 +3083 111 3704 3702 3703 +3084 111 3707 3705 3706 +3085 111 3710 3708 3709 +3086 111 3713 3711 3712 +3087 111 3716 3714 3715 +3088 111 3719 3717 3718 +3089 111 3722 3720 3721 +3090 111 3725 3723 3724 +3091 111 3728 3726 3727 +3092 111 3731 3729 3730 +3093 111 3734 3732 3733 +3094 111 3737 3735 3736 +3095 111 3740 3738 3739 +3096 111 3743 3741 3742 +3097 111 3746 3744 3745 +3098 111 3749 3747 3748 +3099 111 3752 3750 3751 +3100 111 3755 3753 3754 +3101 111 3758 3756 3757 +3102 111 3761 3759 3760 +3103 111 3764 3762 3763 +3104 111 3767 3765 3766 +3105 111 3770 3768 3769 +3106 111 3773 3771 3772 +3107 111 3776 3774 3775 +3108 111 3779 3777 3778 +3109 111 3782 3780 3781 +3110 111 3785 3783 3784 +3111 111 3788 3786 3787 +3112 111 3791 3789 3790 +3113 111 3794 3792 3793 +3114 111 3797 3795 3796 +3115 111 3800 3798 3799 +3116 111 3803 3801 3802 +3117 111 3806 3804 3805 +3118 111 3809 3807 3808 +3119 111 3812 3810 3811 +3120 111 3815 3813 3814 +3121 111 3818 3816 3817 +3122 111 3821 3819 3820 +3123 111 3824 3822 3823 +3124 111 3827 3825 3826 +3125 111 3830 3828 3829 +3126 111 3833 3831 3832 +3127 111 3836 3834 3835 +3128 111 3839 3837 3838 +3129 111 3842 3840 3841 +3130 111 3845 3843 3844 +3131 111 3848 3846 3847 +3132 111 3851 3849 3850 +3133 111 3854 3852 3853 +3134 111 3857 3855 3856 +3135 111 3860 3858 3859 +3136 111 3863 3861 3862 +3137 111 3866 3864 3865 +3138 111 3869 3867 3868 +3139 111 3872 3870 3871 +3140 111 3875 3873 3874 +3141 111 3878 3876 3877 +3142 111 3881 3879 3880 +3143 111 3884 3882 3883 +3144 111 3887 3885 3886 +3145 111 3890 3888 3889 +3146 111 3893 3891 3892 +3147 111 3896 3894 3895 +3148 111 3899 3897 3898 +3149 111 3902 3900 3901 +3150 111 3905 3903 3904 +3151 111 3908 3906 3907 +3152 111 3911 3909 3910 +3153 111 3914 3912 3913 +3154 111 3917 3915 3916 +3155 111 3920 3918 3919 +3156 111 3923 3921 3922 +3157 111 3926 3924 3925 +3158 111 3929 3927 3928 +3159 111 3932 3930 3931 +3160 111 3935 3933 3934 +3161 111 3938 3936 3937 +3162 111 3941 3939 3940 +3163 111 3944 3942 3943 +3164 111 3947 3945 3946 +3165 111 3950 3948 3949 +3166 111 3953 3951 3952 +3167 111 3956 3954 3955 +3168 111 3959 3957 3958 +3169 111 3962 3960 3961 +3170 111 3965 3963 3964 +3171 111 3968 3966 3967 +3172 111 3971 3969 3970 +3173 111 3974 3972 3973 +3174 111 3977 3975 3976 +3175 111 3980 3978 3979 +3176 111 3983 3981 3982 +3177 111 3986 3984 3985 +3178 111 3989 3987 3988 +3179 111 3992 3990 3991 +3180 111 3995 3993 3994 +3181 111 3998 3996 3997 +3182 111 4001 3999 4000 +3183 111 4004 4002 4003 +3184 111 4007 4005 4006 +3185 111 4010 4008 4009 +3186 111 4013 4011 4012 +3187 111 4016 4014 4015 +3188 111 4019 4017 4018 +3189 111 4022 4020 4021 +3190 111 4025 4023 4024 +3191 111 4028 4026 4027 +3192 111 4031 4029 4030 +3193 111 4034 4032 4033 +3194 111 4037 4035 4036 +3195 111 4040 4038 4039 +3196 111 4043 4041 4042 +3197 111 4046 4044 4045 +3198 111 4049 4047 4048 +3199 111 4052 4050 4051 +3200 111 4055 4053 4054 +3201 111 4058 4056 4057 +3202 111 4061 4059 4060 +3203 111 4064 4062 4063 +3204 111 4067 4065 4066 +3205 111 4070 4068 4069 +3206 111 4073 4071 4072 +3207 111 4076 4074 4075 +3208 111 4079 4077 4078 +3209 111 4082 4080 4081 +3210 111 4085 4083 4084 +3211 111 4088 4086 4087 +3212 111 4091 4089 4090 +3213 111 4094 4092 4093 +3214 111 4097 4095 4096 +3215 111 4100 4098 4099 +3216 111 4103 4101 4102 +3217 111 4106 4104 4105 +3218 111 4109 4107 4108 +3219 111 4112 4110 4111 +3220 111 4115 4113 4114 +3221 111 4118 4116 4117 +3222 111 4121 4119 4120 +3223 111 4124 4122 4123 +3224 111 4127 4125 4126 +3225 111 4130 4128 4129 +3226 111 4133 4131 4132 +3227 111 4136 4134 4135 +3228 111 4139 4137 4138 +3229 111 4142 4140 4141 +3230 111 4145 4143 4144 +3231 111 4148 4146 4147 +3232 111 4151 4149 4150 +3233 111 4154 4152 4153 +3234 111 4157 4155 4156 +3235 111 4160 4158 4159 +3236 111 4163 4161 4162 +3237 111 4166 4164 4165 +3238 111 4169 4167 4168 +3239 111 4172 4170 4171 +3240 111 4175 4173 4174 +3241 111 4178 4176 4177 +3242 111 4181 4179 4180 +3243 111 4184 4182 4183 +3244 111 4187 4185 4186 +3245 111 4190 4188 4189 +3246 111 4193 4191 4192 +3247 111 4196 4194 4195 +3248 111 4199 4197 4198 +3249 111 4202 4200 4201 +3250 111 4205 4203 4204 +3251 111 4208 4206 4207 +3252 111 4211 4209 4210 +3253 111 4214 4212 4213 +3254 111 4217 4215 4216 +3255 111 4220 4218 4219 +3256 111 4223 4221 4222 +3257 111 4226 4224 4225 +3258 111 4229 4227 4228 +3259 111 4232 4230 4231 +3260 111 4235 4233 4234 +3261 111 4238 4236 4237 +3262 111 4241 4239 4240 +3263 111 4244 4242 4243 +3264 111 4247 4245 4246 +3265 111 4250 4248 4249 +3266 111 4253 4251 4252 +3267 111 4256 4254 4255 +3268 111 4259 4257 4258 +3269 111 4262 4260 4261 +3270 111 4265 4263 4264 +3271 111 4268 4266 4267 +3272 111 4271 4269 4270 +3273 111 4274 4272 4273 +3274 111 4277 4275 4276 +3275 111 4280 4278 4279 +3276 111 4283 4281 4282 +3277 111 4286 4284 4285 +3278 111 4289 4287 4288 +3279 111 4292 4290 4291 +3280 111 4295 4293 4294 +3281 111 4298 4296 4297 +3282 111 4301 4299 4300 +3283 111 4304 4302 4303 +3284 111 4307 4305 4306 +3285 111 4310 4308 4309 +3286 111 4313 4311 4312 +3287 111 4316 4314 4315 +3288 111 4319 4317 4318 +3289 111 4322 4320 4321 +3290 111 4325 4323 4324 +3291 111 4328 4326 4327 +3292 111 4331 4329 4330 +3293 111 4334 4332 4333 +3294 111 4337 4335 4336 +3295 111 4340 4338 4339 +3296 111 4343 4341 4342 +3297 111 4346 4344 4345 +3298 111 4349 4347 4348 +3299 111 4352 4350 4351 +3300 111 4355 4353 4354 +3301 111 4358 4356 4357 +3302 111 4361 4359 4360 +3303 111 4364 4362 4363 +3304 111 4367 4365 4366 +3305 111 4370 4368 4369 +3306 111 4373 4371 4372 +3307 111 4376 4374 4375 +3308 111 4379 4377 4378 +3309 111 4382 4380 4381 +3310 111 4385 4383 4384 +3311 111 4388 4386 4387 +3312 111 4391 4389 4390 +3313 111 4394 4392 4393 +3314 111 4397 4395 4396 +3315 111 4400 4398 4399 +3316 111 4403 4401 4402 +3317 111 4406 4404 4405 +3318 111 4409 4407 4408 +3319 111 4412 4410 4411 +3320 111 4415 4413 4414 +3321 111 4418 4416 4417 +3322 111 4421 4419 4420 +3323 111 4424 4422 4423 +3324 111 4427 4425 4426 +3325 111 4430 4428 4429 +3326 111 4433 4431 4432 +3327 111 4436 4434 4435 +3328 111 4439 4437 4438 +3329 111 4442 4440 4441 +3330 111 4445 4443 4444 +3331 111 4448 4446 4447 +3332 111 4451 4449 4450 +3333 111 4454 4452 4453 +3334 111 4457 4455 4456 +3335 111 4460 4458 4459 +3336 111 4463 4461 4462 +3337 111 4466 4464 4465 +3338 111 4469 4467 4468 +3339 111 4472 4470 4471 +3340 111 4475 4473 4474 +3341 111 4478 4476 4477 +3342 111 4481 4479 4480 +3343 111 4484 4482 4483 +3344 111 4487 4485 4486 +3345 111 4490 4488 4489 +3346 111 4493 4491 4492 +3347 111 4496 4494 4495 +3348 111 4499 4497 4498 +3349 111 4502 4500 4501 +3350 111 4505 4503 4504 +3351 111 4508 4506 4507 +3352 111 4511 4509 4510 +3353 111 4514 4512 4513 +3354 111 4517 4515 4516 +3355 111 4520 4518 4519 +3356 111 4523 4521 4522 +3357 111 4526 4524 4525 +3358 111 4529 4527 4528 +3359 111 4532 4530 4531 +3360 111 4535 4533 4534 +3361 111 4538 4536 4537 +3362 111 4541 4539 4540 +3363 111 4544 4542 4543 +3364 111 4547 4545 4546 +3365 111 4550 4548 4549 +3366 111 4553 4551 4552 +3367 111 4556 4554 4555 +3368 111 4559 4557 4558 +3369 111 4562 4560 4561 +3370 111 4565 4563 4564 +3371 111 4568 4566 4567 +3372 111 4571 4569 4570 +3373 111 4574 4572 4573 +3374 111 4577 4575 4576 +3375 111 4580 4578 4579 +3376 111 4583 4581 4582 +3377 111 4586 4584 4585 +3378 111 4589 4587 4588 +3379 111 4592 4590 4591 +3380 111 4595 4593 4594 +3381 111 4598 4596 4597 +3382 111 4601 4599 4600 +3383 111 4604 4602 4603 +3384 111 4607 4605 4606 +3385 111 4610 4608 4609 +3386 111 4613 4611 4612 +3387 111 4616 4614 4615 +3388 111 4619 4617 4618 +3389 111 4622 4620 4621 +3390 111 4625 4623 4624 +3391 111 4628 4626 4627 +3392 111 4631 4629 4630 +3393 111 4634 4632 4633 +3394 111 4637 4635 4636 +3395 111 4640 4638 4639 +3396 111 4643 4641 4642 +3397 111 4646 4644 4645 +3398 111 4649 4647 4648 +3399 111 4652 4650 4651 +3400 111 4655 4653 4654 +3401 111 4658 4656 4657 +3402 111 4661 4659 4660 +3403 111 4664 4662 4663 +3404 111 4667 4665 4666 +3405 111 4670 4668 4669 +3406 111 4673 4671 4672 +3407 111 4676 4674 4675 +3408 111 4679 4677 4678 +3409 111 4682 4680 4681 +3410 111 4685 4683 4684 +3411 111 4688 4686 4687 +3412 111 4691 4689 4690 +3413 111 4694 4692 4693 +3414 111 4697 4695 4696 +3415 111 4700 4698 4699 +3416 111 4703 4701 4702 +3417 111 4706 4704 4705 +3418 111 4709 4707 4708 +3419 111 4712 4710 4711 +3420 111 4715 4713 4714 +3421 111 4718 4716 4717 +3422 111 4721 4719 4720 +3423 111 4724 4722 4723 +3424 111 4727 4725 4726 +3425 111 4730 4728 4729 +3426 111 4733 4731 4732 +3427 111 4736 4734 4735 +3428 111 4739 4737 4738 +3429 111 4742 4740 4741 +3430 111 4745 4743 4744 +3431 111 4748 4746 4747 +3432 111 4751 4749 4750 +3433 111 4754 4752 4753 +3434 111 4757 4755 4756 +3435 111 4760 4758 4759 +3436 111 4763 4761 4762 +3437 111 4766 4764 4765 +3438 111 4769 4767 4768 +3439 111 4772 4770 4771 +3440 111 4775 4773 4774 +3441 111 4778 4776 4777 +3442 111 4781 4779 4780 +3443 111 4784 4782 4783 +3444 111 4787 4785 4786 +3445 111 4790 4788 4789 +3446 111 4793 4791 4792 +3447 111 4796 4794 4795 +3448 111 4799 4797 4798 +3449 111 4802 4800 4801 +3450 111 4805 4803 4804 +3451 111 4808 4806 4807 +3452 111 4811 4809 4810 +3453 111 4814 4812 4813 +3454 111 4817 4815 4816 +3455 111 4820 4818 4819 +3456 111 4823 4821 4822 +3457 111 4826 4824 4825 +3458 111 4829 4827 4828 +3459 111 4832 4830 4831 +3460 111 4835 4833 4834 +3461 111 4838 4836 4837 +3462 111 4841 4839 4840 +3463 111 4844 4842 4843 +3464 111 4847 4845 4846 +3465 111 4850 4848 4849 +3466 111 4853 4851 4852 +3467 111 4856 4854 4855 +3468 111 4859 4857 4858 +3469 111 4862 4860 4861 +3470 111 4865 4863 4864 +3471 111 4868 4866 4867 +3472 111 4871 4869 4870 +3473 111 4874 4872 4873 +3474 111 4877 4875 4876 +3475 111 4880 4878 4879 +3476 111 4883 4881 4882 +3477 111 4886 4884 4885 +3478 111 4889 4887 4888 +3479 111 4892 4890 4891 +3480 111 4895 4893 4894 +3481 111 4898 4896 4897 +3482 111 4901 4899 4900 +3483 111 4904 4902 4903 +3484 111 4907 4905 4906 +3485 111 4910 4908 4909 +3486 111 4913 4911 4912 +3487 111 4916 4914 4915 +3488 111 4919 4917 4918 +3489 111 4922 4920 4921 +3490 111 4925 4923 4924 +3491 111 4928 4926 4927 +3492 111 4931 4929 4930 +3493 111 4934 4932 4933 +3494 111 4937 4935 4936 +3495 111 4940 4938 4939 +3496 111 4943 4941 4942 +3497 111 4946 4944 4945 +3498 111 4949 4947 4948 +3499 111 4952 4950 4951 +3500 111 4955 4953 4954 +3501 111 4958 4956 4957 +3502 111 4961 4959 4960 +3503 111 4964 4962 4963 +3504 111 4967 4965 4966 +3505 111 4970 4968 4969 +3506 111 4973 4971 4972 +3507 111 4976 4974 4975 +3508 111 4979 4977 4978 +3509 111 4982 4980 4981 +3510 111 4985 4983 4984 +3511 111 4988 4986 4987 +3512 111 4991 4989 4990 +3513 111 4994 4992 4993 +3514 111 4997 4995 4996 +3515 111 5000 4998 4999 +3516 111 5003 5001 5002 +3517 111 5006 5004 5005 +3518 111 5009 5007 5008 +3519 111 5012 5010 5011 +3520 111 5015 5013 5014 +3521 111 5018 5016 5017 +3522 111 5021 5019 5020 +3523 111 5024 5022 5023 +3524 111 5027 5025 5026 +3525 111 5030 5028 5029 +3526 111 5033 5031 5032 +3527 111 5036 5034 5035 +3528 111 5039 5037 5038 +3529 111 5042 5040 5041 +3530 111 5045 5043 5044 +3531 111 5048 5046 5047 +3532 111 5051 5049 5050 +3533 111 5054 5052 5053 +3534 111 5057 5055 5056 +3535 111 5060 5058 5059 +3536 111 5063 5061 5062 +3537 111 5066 5064 5065 +3538 111 5069 5067 5068 +3539 111 5072 5070 5071 +3540 111 5075 5073 5074 +3541 111 5078 5076 5077 +3542 111 5081 5079 5080 +3543 111 5084 5082 5083 +3544 111 5087 5085 5086 +3545 111 5090 5088 5089 +3546 111 5093 5091 5092 +3547 111 5096 5094 5095 +3548 111 5099 5097 5098 +3549 111 5102 5100 5101 +3550 111 5105 5103 5104 +3551 111 5108 5106 5107 +3552 111 5111 5109 5110 +3553 111 5114 5112 5113 +3554 111 5117 5115 5116 +3555 111 5120 5118 5119 +3556 111 5123 5121 5122 +3557 111 5126 5124 5125 +3558 111 5129 5127 5128 +3559 111 5132 5130 5131 +3560 111 5135 5133 5134 +3561 111 5138 5136 5137 +3562 111 5141 5139 5140 +3563 111 5144 5142 5143 +3564 111 5147 5145 5146 +3565 111 5150 5148 5149 +3566 111 5153 5151 5152 +3567 111 5156 5154 5155 +3568 111 5159 5157 5158 +3569 111 5162 5160 5161 +3570 111 5165 5163 5164 +3571 111 5168 5166 5167 +3572 111 5171 5169 5170 +3573 111 5174 5172 5173 +3574 111 5177 5175 5176 +3575 111 5180 5178 5179 +3576 111 5183 5181 5182 +3577 111 5186 5184 5185 +3578 111 5189 5187 5188 +3579 111 5192 5190 5191 +3580 111 5195 5193 5194 +3581 111 5198 5196 5197 +3582 111 5201 5199 5200 +3583 111 5204 5202 5203 +3584 111 5207 5205 5206 +3585 111 5210 5208 5209 +3586 111 5213 5211 5212 +3587 111 5216 5214 5215 +3588 111 5219 5217 5218 +3589 111 5222 5220 5221 +3590 111 5225 5223 5224 +3591 111 5228 5226 5227 +3592 111 5231 5229 5230 +3593 111 5234 5232 5233 +3594 111 5237 5235 5236 +3595 111 5240 5238 5239 +3596 111 5243 5241 5242 +3597 111 5246 5244 5245 +3598 111 5249 5247 5248 +3599 111 5252 5250 5251 +3600 111 5255 5253 5254 +3601 111 5258 5256 5257 +3602 111 5261 5259 5260 +3603 111 5264 5262 5263 +3604 111 5267 5265 5266 +3605 111 5270 5268 5269 +3606 111 5273 5271 5272 +3607 111 5276 5274 5275 +3608 111 5279 5277 5278 +3609 111 5282 5280 5281 +3610 111 5285 5283 5284 +3611 111 5288 5286 5287 +3612 111 5291 5289 5290 +3613 111 5294 5292 5293 +3614 111 5297 5295 5296 +3615 111 5300 5298 5299 +3616 111 5303 5301 5302 +3617 111 5306 5304 5305 +3618 111 5309 5307 5308 +3619 111 5312 5310 5311 +3620 111 5315 5313 5314 +3621 111 5318 5316 5317 +3622 111 5321 5319 5320 +3623 111 5324 5322 5323 +3624 111 5327 5325 5326 +3625 111 5330 5328 5329 +3626 111 5333 5331 5332 +3627 111 5336 5334 5335 +3628 111 5339 5337 5338 +3629 111 5342 5340 5341 +3630 111 5345 5343 5344 +3631 111 5348 5346 5347 +3632 111 5351 5349 5350 +3633 111 5354 5352 5353 +3634 111 5357 5355 5356 +3635 111 5360 5358 5359 +3636 111 5363 5361 5362 +3637 111 5366 5364 5365 +3638 111 5369 5367 5368 +3639 111 5372 5370 5371 +3640 111 5375 5373 5374 +3641 111 5378 5376 5377 +3642 111 5381 5379 5380 +3643 111 5384 5382 5383 +3644 111 5387 5385 5386 +3645 111 5390 5388 5389 +3646 111 5393 5391 5392 +3647 111 5396 5394 5395 +3648 111 5399 5397 5398 +3649 111 5402 5400 5401 +3650 111 5405 5403 5404 +3651 111 5408 5406 5407 +3652 111 5411 5409 5410 +3653 111 5414 5412 5413 +3654 111 5417 5415 5416 +3655 111 5420 5418 5419 +3656 111 5423 5421 5422 +3657 111 5426 5424 5425 +3658 111 5429 5427 5428 +3659 111 5432 5430 5431 +3660 111 5435 5433 5434 +3661 111 5438 5436 5437 +3662 111 5441 5439 5440 +3663 111 5444 5442 5443 +3664 111 5447 5445 5446 +3665 111 5450 5448 5449 +3666 111 5453 5451 5452 +3667 111 5456 5454 5455 +3668 111 5459 5457 5458 +3669 111 5462 5460 5461 +3670 111 5465 5463 5464 +3671 111 5468 5466 5467 +3672 111 5471 5469 5470 +3673 111 5474 5472 5473 +3674 111 5477 5475 5476 +3675 111 5480 5478 5479 +3676 111 5483 5481 5482 +3677 111 5486 5484 5485 +3678 111 5489 5487 5488 +3679 111 5492 5490 5491 +3680 111 5495 5493 5494 +3681 111 5498 5496 5497 +3682 111 5501 5499 5500 +3683 111 5504 5502 5503 +3684 111 5507 5505 5506 +3685 111 5510 5508 5509 +3686 111 5513 5511 5512 +3687 111 5516 5514 5515 +3688 111 5519 5517 5518 +3689 111 5522 5520 5521 +3690 111 5525 5523 5524 +3691 111 5528 5526 5527 +3692 111 5531 5529 5530 +3693 111 5534 5532 5533 +3694 111 5537 5535 5536 +3695 111 5540 5538 5539 +3696 111 5543 5541 5542 +3697 111 5546 5544 5545 +3698 111 5549 5547 5548 +3699 111 5552 5550 5551 +3700 111 5555 5553 5554 +3701 111 5558 5556 5557 +3702 111 5561 5559 5560 +3703 111 5564 5562 5563 +3704 111 5567 5565 5566 +3705 111 5570 5568 5569 +3706 111 5573 5571 5572 +3707 111 5576 5574 5575 +3708 111 5579 5577 5578 +3709 111 5582 5580 5581 +3710 111 5585 5583 5584 +3711 111 5588 5586 5587 +3712 111 5591 5589 5590 +3713 111 5594 5592 5593 +3714 111 5597 5595 5596 +3715 111 5600 5598 5599 +3716 111 5603 5601 5602 +3717 111 5606 5604 5605 +3718 111 5609 5607 5608 +3719 111 5612 5610 5611 +3720 111 5615 5613 5614 +3721 111 5618 5616 5617 +3722 111 5621 5619 5620 +3723 111 5624 5622 5623 +3724 111 5627 5625 5626 +3725 111 5630 5628 5629 +3726 111 5633 5631 5632 +3727 111 5636 5634 5635 +3728 111 5639 5637 5638 +3729 111 5642 5640 5641 +3730 111 5645 5643 5644 +3731 111 5648 5646 5647 +3732 111 5651 5649 5650 +3733 111 5654 5652 5653 +3734 111 5657 5655 5656 +3735 111 5660 5658 5659 +3736 111 5663 5661 5662 +3737 111 5666 5664 5665 +3738 111 5669 5667 5668 +3739 111 5672 5670 5671 +3740 111 5675 5673 5674 +3741 111 5678 5676 5677 +3742 111 5681 5679 5680 +3743 111 5684 5682 5683 +3744 111 5687 5685 5686 +3745 111 5690 5688 5689 +3746 111 5693 5691 5692 +3747 111 5696 5694 5695 +3748 111 5699 5697 5698 +3749 111 5702 5700 5701 +3750 111 5705 5703 5704 +3751 111 5708 5706 5707 +3752 111 5711 5709 5710 +3753 111 5714 5712 5713 +3754 111 5717 5715 5716 +3755 111 5720 5718 5719 +3756 111 5723 5721 5722 +3757 111 5726 5724 5725 +3758 111 5729 5727 5728 +3759 111 5732 5730 5731 +3760 111 5735 5733 5734 +3761 111 5738 5736 5737 +3762 111 5741 5739 5740 +3763 111 5744 5742 5743 +3764 111 5747 5745 5746 +3765 111 5750 5748 5749 +3766 111 5753 5751 5752 +3767 111 5756 5754 5755 +3768 111 5759 5757 5758 +3769 111 5762 5760 5761 +3770 111 5765 5763 5764 +3771 111 5768 5766 5767 +3772 111 5771 5769 5770 +3773 111 5774 5772 5773 +3774 111 5777 5775 5776 +3775 111 5780 5778 5779 +3776 111 5783 5781 5782 +3777 111 5786 5784 5785 +3778 111 5789 5787 5788 +3779 111 5792 5790 5791 +3780 111 5795 5793 5794 +3781 111 5798 5796 5797 +3782 111 5801 5799 5800 +3783 111 5804 5802 5803 +3784 111 5807 5805 5806 +3785 111 5810 5808 5809 +3786 111 5813 5811 5812 +3787 111 5816 5814 5815 +3788 111 5819 5817 5818 +3789 111 5822 5820 5821 +3790 111 5825 5823 5824 +3791 111 5828 5826 5827 +3792 111 5831 5829 5830 +3793 111 5834 5832 5833 +3794 111 5837 5835 5836 +3795 111 5840 5838 5839 +3796 111 5843 5841 5842 +3797 111 5846 5844 5845 +3798 111 5849 5847 5848 +3799 111 5852 5850 5851 +3800 111 5855 5853 5854 +3801 111 5858 5856 5857 +3802 111 5861 5859 5860 +3803 111 5864 5862 5863 +3804 111 5867 5865 5866 +3805 111 5870 5868 5869 +3806 111 5873 5871 5872 +3807 111 5876 5874 5875 +3808 111 5879 5877 5878 +3809 111 5882 5880 5881 +3810 111 5885 5883 5884 +3811 111 5888 5886 5887 +3812 111 5891 5889 5890 +3813 111 5894 5892 5893 +3814 111 5897 5895 5896 +3815 111 5900 5898 5899 +3816 111 5903 5901 5902 +3817 111 5906 5904 5905 +3818 111 5909 5907 5908 +3819 111 5912 5910 5911 +3820 111 5915 5913 5914 +3821 111 5918 5916 5917 +3822 111 5921 5919 5920 +3823 111 5924 5922 5923 +3824 111 5927 5925 5926 +3825 111 5930 5928 5929 +3826 111 5933 5931 5932 +3827 111 5936 5934 5935 +3828 111 5939 5937 5938 +3829 111 5942 5940 5941 +3830 111 5945 5943 5944 +3831 111 5948 5946 5947 +3832 111 5951 5949 5950 +3833 111 5954 5952 5953 +3834 111 5957 5955 5956 +3835 111 5960 5958 5959 +3836 111 5963 5961 5962 +3837 111 5966 5964 5965 +3838 111 5969 5967 5968 +3839 111 5972 5970 5971 +3840 111 5975 5973 5974 +3841 111 5978 5976 5977 +3842 111 5981 5979 5980 +3843 111 5984 5982 5983 +3844 111 5987 5985 5986 +3845 111 5990 5988 5989 +3846 111 5993 5991 5992 +3847 111 5996 5994 5995 +3848 111 5999 5997 5998 +3849 111 6002 6000 6001 +3850 111 6005 6003 6004 +3851 111 6008 6006 6007 +3852 111 6011 6009 6010 +3853 111 6014 6012 6013 +3854 111 6017 6015 6016 +3855 111 6020 6018 6019 +3856 111 6023 6021 6022 +3857 111 6026 6024 6025 +3858 111 6029 6027 6028 +3859 111 6032 6030 6031 +3860 111 6035 6033 6034 +3861 111 6038 6036 6037 +3862 111 6041 6039 6040 +3863 111 6044 6042 6043 +3864 111 6047 6045 6046 +3865 111 6050 6048 6049 +3866 111 6053 6051 6052 +3867 111 6056 6054 6055 +3868 111 6059 6057 6058 +3869 111 6062 6060 6061 +3870 111 6065 6063 6064 +3871 111 6068 6066 6067 +3872 111 6071 6069 6070 +3873 111 6074 6072 6073 +3874 111 6077 6075 6076 +3875 111 6080 6078 6079 +3876 111 6083 6081 6082 +3877 111 6086 6084 6085 +3878 111 6089 6087 6088 +3879 111 6092 6090 6091 +3880 111 6095 6093 6094 +3881 111 6098 6096 6097 +3882 111 6101 6099 6100 +3883 111 6104 6102 6103 +3884 111 6107 6105 6106 +3885 111 6110 6108 6109 +3886 111 6113 6111 6112 +3887 111 6116 6114 6115 +3888 111 6119 6117 6118 +3889 111 6122 6120 6121 +3890 111 6125 6123 6124 +3891 111 6128 6126 6127 +3892 111 6131 6129 6130 +3893 111 6134 6132 6133 +3894 111 6137 6135 6136 +3895 111 6140 6138 6139 +3896 111 6143 6141 6142 +3897 111 6146 6144 6145 +3898 111 6149 6147 6148 +3899 111 6152 6150 6151 +3900 111 6155 6153 6154 +3901 111 6158 6156 6157 +3902 111 6161 6159 6160 +3903 111 6164 6162 6163 +3904 111 6167 6165 6166 +3905 111 6170 6168 6169 +3906 111 6173 6171 6172 +3907 111 6176 6174 6175 +3908 111 6179 6177 6178 +3909 111 6182 6180 6181 +3910 111 6185 6183 6184 +3911 111 6188 6186 6187 +3912 111 6191 6189 6190 +3913 111 6194 6192 6193 +3914 111 6197 6195 6196 +3915 111 6200 6198 6199 +3916 111 6203 6201 6202 +3917 111 6206 6204 6205 +3918 111 6209 6207 6208 +3919 111 6212 6210 6211 +3920 111 6215 6213 6214 +3921 111 6218 6216 6217 +3922 111 6221 6219 6220 +3923 111 6224 6222 6223 +3924 111 6227 6225 6226 +3925 111 6230 6228 6229 +3926 111 6233 6231 6232 +3927 111 6236 6234 6235 +3928 111 6239 6237 6238 +3929 111 6242 6240 6241 +3930 111 6245 6243 6244 +3931 111 6248 6246 6247 +3932 111 6251 6249 6250 +3933 111 6254 6252 6253 +3934 111 6257 6255 6256 +3935 111 6260 6258 6259 +3936 111 6263 6261 6262 +3937 111 6266 6264 6265 +3938 111 6269 6267 6268 +3939 111 6272 6270 6271 +3940 111 6275 6273 6274 +3941 111 6278 6276 6277 +3942 111 6281 6279 6280 +3943 111 6284 6282 6283 +3944 111 6287 6285 6286 +3945 111 6290 6288 6289 +3946 111 6293 6291 6292 +3947 111 6296 6294 6295 +3948 111 6299 6297 6298 +3949 111 6302 6300 6301 +3950 111 6305 6303 6304 +3951 111 6308 6306 6307 +3952 111 6311 6309 6310 +3953 111 6314 6312 6313 +3954 111 6317 6315 6316 +3955 111 6320 6318 6319 +3956 111 6323 6321 6322 +3957 111 6326 6324 6325 +3958 111 6329 6327 6328 +3959 111 6332 6330 6331 +3960 111 6335 6333 6334 +3961 111 6338 6336 6337 +3962 111 6341 6339 6340 +3963 111 6344 6342 6343 +3964 111 6347 6345 6346 +3965 111 6350 6348 6349 +3966 111 6353 6351 6352 +3967 111 6356 6354 6355 +3968 111 6359 6357 6358 +3969 111 6362 6360 6361 +3970 111 6365 6363 6364 +3971 111 6368 6366 6367 +3972 111 6371 6369 6370 +3973 111 6374 6372 6373 +3974 111 6377 6375 6376 +3975 111 6380 6378 6379 +3976 111 6383 6381 6382 +3977 111 6386 6384 6385 +3978 111 6389 6387 6388 +3979 111 6392 6390 6391 +3980 111 6395 6393 6394 +3981 111 6398 6396 6397 +3982 111 6401 6399 6400 +3983 111 6404 6402 6403 +3984 111 6407 6405 6406 +3985 111 6410 6408 6409 +3986 111 6413 6411 6412 +3987 111 6416 6414 6415 +3988 111 6419 6417 6418 +3989 111 6422 6420 6421 +3990 111 6425 6423 6424 +3991 111 6428 6426 6427 +3992 111 6431 6429 6430 +3993 111 6434 6432 6433 +3994 111 6437 6435 6436 +3995 111 6440 6438 6439 +3996 111 6443 6441 6442 +3997 111 6446 6444 6445 +3998 111 6449 6447 6448 +3999 111 6452 6450 6451 +4000 111 6455 6453 6454 +4001 111 6458 6456 6457 +4002 111 6461 6459 6460 +4003 111 6464 6462 6463 +4004 111 6467 6465 6466 +4005 111 6470 6468 6469 +4006 111 6473 6471 6472 +4007 111 6476 6474 6475 +4008 111 6479 6477 6478 +4009 111 6482 6480 6481 +4010 111 6485 6483 6484 +4011 111 6488 6486 6487 +4012 111 6491 6489 6490 +4013 111 6494 6492 6493 +4014 111 6497 6495 6496 +4015 111 6500 6498 6499 +4016 111 6503 6501 6502 +4017 111 6506 6504 6505 +4018 111 6509 6507 6508 +4019 111 6512 6510 6511 +4020 111 6515 6513 6514 +4021 111 6518 6516 6517 +4022 111 6521 6519 6520 +4023 111 6524 6522 6523 +4024 111 6527 6525 6526 +4025 111 6530 6528 6529 +4026 111 6533 6531 6532 +4027 111 6536 6534 6535 +4028 111 6539 6537 6538 +4029 111 6542 6540 6541 +4030 111 6545 6543 6544 +4031 111 6548 6546 6547 +4032 111 6551 6549 6550 +4033 111 6554 6552 6553 +4034 111 6557 6555 6556 +4035 111 6560 6558 6559 +4036 111 6563 6561 6562 +4037 111 6566 6564 6565 +4038 111 6569 6567 6568 +4039 111 6572 6570 6571 +4040 111 6575 6573 6574 +4041 111 6578 6576 6577 +4042 111 6581 6579 6580 +4043 111 6584 6582 6583 +4044 111 6587 6585 6586 +4045 111 6590 6588 6589 +4046 111 6593 6591 6592 +4047 111 6596 6594 6595 +4048 111 6599 6597 6598 +4049 111 6602 6600 6601 +4050 111 6605 6603 6604 +4051 111 6608 6606 6607 +4052 111 6611 6609 6610 +4053 111 6614 6612 6613 +4054 111 6617 6615 6616 +4055 111 6620 6618 6619 +4056 111 6623 6621 6622 +4057 111 6626 6624 6625 +4058 111 6629 6627 6628 +4059 111 6632 6630 6631 +4060 111 6635 6633 6634 +4061 111 6638 6636 6637 +4062 111 6641 6639 6640 +4063 111 6644 6642 6643 +4064 111 6647 6645 6646 +4065 111 6650 6648 6649 +4066 111 6653 6651 6652 +4067 111 6656 6654 6655 +4068 111 6659 6657 6658 +4069 111 6662 6660 6661 +4070 111 6665 6663 6664 +4071 111 6668 6666 6667 +4072 111 6671 6669 6670 +4073 111 6674 6672 6673 +4074 111 6677 6675 6676 +4075 111 6680 6678 6679 +4076 111 6683 6681 6682 +4077 111 6686 6684 6685 +4078 111 6689 6687 6688 +4079 111 6692 6690 6691 +4080 111 6695 6693 6694 +4081 111 6698 6696 6697 +4082 111 6701 6699 6700 +4083 111 6704 6702 6703 +4084 111 6707 6705 6706 +4085 111 6710 6708 6709 +4086 111 6713 6711 6712 +4087 111 6716 6714 6715 +4088 111 6719 6717 6718 +4089 111 6722 6720 6721 +4090 111 6725 6723 6724 +4091 111 6728 6726 6727 +4092 111 6731 6729 6730 +4093 111 6734 6732 6733 +4094 111 6737 6735 6736 +4095 111 6740 6738 6739 +4096 111 6743 6741 6742 +4097 111 6746 6744 6745 +4098 111 6749 6747 6748 +4099 111 6752 6750 6751 +4100 111 6755 6753 6754 +4101 111 6758 6756 6757 +4102 111 6761 6759 6760 +4103 111 6764 6762 6763 +4104 111 6767 6765 6766 +4105 111 6770 6768 6769 +4106 111 6773 6771 6772 +4107 111 6776 6774 6775 +4108 111 6779 6777 6778 +4109 111 6782 6780 6781 +4110 111 6785 6783 6784 +4111 111 6788 6786 6787 +4112 111 6791 6789 6790 +4113 111 6794 6792 6793 +4114 111 6797 6795 6796 +4115 111 6800 6798 6799 +4116 111 6803 6801 6802 +4117 111 6806 6804 6805 +4118 111 6809 6807 6808 +4119 111 6812 6810 6811 +4120 111 6815 6813 6814 +4121 111 6818 6816 6817 +4122 111 6821 6819 6820 +4123 111 6824 6822 6823 +4124 111 6827 6825 6826 +4125 111 6830 6828 6829 +4126 111 6833 6831 6832 +4127 111 6836 6834 6835 +4128 111 6839 6837 6838 +4129 111 6842 6840 6841 +4130 111 6845 6843 6844 +4131 111 6848 6846 6847 +4132 111 6851 6849 6850 +4133 111 6854 6852 6853 +4134 111 6857 6855 6856 +4135 111 6860 6858 6859 +4136 111 6863 6861 6862 +4137 111 6866 6864 6865 +4138 111 6869 6867 6868 +4139 111 6872 6870 6871 +4140 111 6875 6873 6874 +4141 111 6878 6876 6877 +4142 111 6881 6879 6880 +4143 111 6884 6882 6883 +4144 111 6887 6885 6886 +4145 111 6890 6888 6889 +4146 111 6893 6891 6892 +4147 111 6896 6894 6895 +4148 111 6899 6897 6898 +4149 111 6902 6900 6901 +4150 111 6905 6903 6904 +4151 111 6908 6906 6907 +4152 111 6911 6909 6910 +4153 111 6914 6912 6913 +4154 111 6917 6915 6916 +4155 111 6920 6918 6919 +4156 111 6923 6921 6922 +4157 111 6926 6924 6925 +4158 111 6929 6927 6928 +4159 111 6932 6930 6931 +4160 111 6935 6933 6934 +4161 111 6938 6936 6937 +4162 111 6941 6939 6940 +4163 111 6944 6942 6943 +4164 111 6947 6945 6946 +4165 111 6950 6948 6949 +4166 111 6953 6951 6952 +4167 111 6956 6954 6955 +4168 111 6959 6957 6958 +4169 111 6962 6960 6961 +4170 111 6965 6963 6964 +4171 111 6968 6966 6967 +4172 111 6971 6969 6970 +4173 111 6974 6972 6973 +4174 111 6977 6975 6976 +4175 111 6980 6978 6979 +4176 111 6983 6981 6982 +4177 111 6986 6984 6985 +4178 111 6989 6987 6988 +4179 111 6992 6990 6991 +4180 111 6995 6993 6994 +4181 111 6998 6996 6997 +4182 111 7001 6999 7000 +4183 111 7004 7002 7003 +4184 111 7007 7005 7006 +4185 111 7010 7008 7009 +4186 111 7013 7011 7012 +4187 111 7016 7014 7015 +4188 111 7019 7017 7018 +4189 111 7022 7020 7021 +4190 111 7025 7023 7024 +4191 111 7028 7026 7027 +4192 111 7031 7029 7030 +4193 111 7034 7032 7033 +4194 111 7037 7035 7036 +4195 111 7040 7038 7039 +4196 111 7043 7041 7042 +4197 111 7046 7044 7045 +4198 111 7049 7047 7048 +4199 111 7052 7050 7051 +4200 111 7055 7053 7054 +4201 111 7058 7056 7057 +4202 111 7061 7059 7060 +4203 111 7064 7062 7063 +4204 111 7067 7065 7066 +4205 111 7070 7068 7069 +4206 111 7073 7071 7072 +4207 111 7076 7074 7075 +4208 111 7079 7077 7078 +4209 111 7082 7080 7081 +4210 111 7085 7083 7084 +4211 111 7088 7086 7087 +4212 111 7091 7089 7090 +4213 111 7094 7092 7093 +4214 111 7097 7095 7096 +4215 111 7100 7098 7099 +4216 111 7103 7101 7102 +4217 111 7106 7104 7105 +4218 111 7109 7107 7108 +4219 111 7112 7110 7111 +4220 111 7115 7113 7114 +4221 111 7118 7116 7117 +4222 111 7121 7119 7120 +4223 111 7124 7122 7123 +4224 111 7127 7125 7126 +4225 111 7130 7128 7129 +4226 111 7133 7131 7132 +4227 111 7136 7134 7135 +4228 111 7139 7137 7138 +4229 111 7142 7140 7141 +4230 111 7145 7143 7144 +4231 111 7148 7146 7147 +4232 111 7151 7149 7150 +4233 111 7154 7152 7153 +4234 111 7157 7155 7156 +4235 111 7160 7158 7159 +4236 111 7163 7161 7162 +4237 111 7166 7164 7165 +4238 111 7169 7167 7168 +4239 111 7172 7170 7171 +4240 111 7175 7173 7174 +4241 111 7178 7176 7177 +4242 111 7181 7179 7180 +4243 111 7184 7182 7183 +4244 111 7187 7185 7186 +4245 111 7190 7188 7189 +4246 111 7193 7191 7192 +4247 111 7196 7194 7195 +4248 111 7199 7197 7198 +4249 111 7202 7200 7201 +4250 111 7205 7203 7204 +4251 111 7208 7206 7207 +4252 111 7211 7209 7210 +4253 111 7214 7212 7213 +4254 111 7217 7215 7216 +4255 111 7220 7218 7219 +4256 111 7223 7221 7222 +4257 111 7226 7224 7225 +4258 111 7229 7227 7228 +4259 111 7232 7230 7231 +4260 111 7235 7233 7234 +4261 111 7238 7236 7237 +4262 111 7241 7239 7240 +4263 111 7244 7242 7243 +4264 111 7247 7245 7246 +4265 111 7250 7248 7249 +4266 111 7253 7251 7252 +4267 111 7256 7254 7255 +4268 111 7259 7257 7258 +4269 111 7262 7260 7261 +4270 111 7265 7263 7264 +4271 111 7268 7266 7267 +4272 111 7271 7269 7270 +4273 111 7274 7272 7273 +4274 111 7277 7275 7276 +4275 111 7280 7278 7279 +4276 111 7283 7281 7282 +4277 111 7286 7284 7285 +4278 111 7289 7287 7288 +4279 111 7292 7290 7291 +4280 111 7295 7293 7294 +4281 111 7298 7296 7297 +4282 111 7301 7299 7300 +4283 111 7304 7302 7303 +4284 111 7307 7305 7306 +4285 111 7310 7308 7309 +4286 111 7313 7311 7312 +4287 111 7316 7314 7315 +4288 111 7319 7317 7318 +4289 111 7322 7320 7321 +4290 111 7325 7323 7324 +4291 111 7328 7326 7327 +4292 111 7331 7329 7330 +4293 111 7334 7332 7333 +4294 111 7337 7335 7336 +4295 111 7340 7338 7339 +4296 111 7343 7341 7342 +4297 111 7346 7344 7345 +4298 111 7349 7347 7348 +4299 111 7352 7350 7351 +4300 111 7355 7353 7354 +4301 111 7358 7356 7357 +4302 111 7361 7359 7360 +4303 111 7364 7362 7363 +4304 111 7367 7365 7366 +4305 111 7370 7368 7369 +4306 111 7373 7371 7372 +4307 111 7376 7374 7375 +4308 111 7379 7377 7378 +4309 111 7382 7380 7381 +4310 111 7385 7383 7384 +4311 111 7388 7386 7387 +4312 111 7391 7389 7390 +4313 111 7394 7392 7393 +4314 111 7397 7395 7396 +4315 111 7400 7398 7399 +4316 111 7403 7401 7402 +4317 111 7406 7404 7405 +4318 111 7409 7407 7408 +4319 111 7412 7410 7411 +4320 111 7415 7413 7414 +4321 111 7418 7416 7417 +4322 111 7421 7419 7420 +4323 111 7424 7422 7423 +4324 111 7427 7425 7426 +4325 111 7430 7428 7429 +4326 111 7433 7431 7432 +4327 111 7436 7434 7435 +4328 111 7439 7437 7438 +4329 111 7442 7440 7441 +4330 111 7445 7443 7444 +4331 111 7448 7446 7447 +4332 111 7451 7449 7450 +4333 111 7454 7452 7453 +4334 111 7457 7455 7456 +4335 111 7460 7458 7459 +4336 111 7463 7461 7462 +4337 111 7466 7464 7465 +4338 111 7469 7467 7468 +4339 111 7472 7470 7471 +4340 111 7475 7473 7474 +4341 111 7478 7476 7477 +4342 111 7481 7479 7480 +4343 111 7484 7482 7483 +4344 111 7487 7485 7486 +4345 111 7490 7488 7489 +4346 111 7493 7491 7492 +4347 111 7496 7494 7495 +4348 111 7499 7497 7498 +4349 111 7502 7500 7501 +4350 111 7505 7503 7504 +4351 111 7508 7506 7507 +4352 111 7511 7509 7510 +4353 111 7514 7512 7513 +4354 111 7517 7515 7516 +4355 111 7520 7518 7519 +4356 111 7523 7521 7522 +4357 111 7526 7524 7525 +4358 111 7529 7527 7528 +4359 111 7532 7530 7531 +4360 111 7535 7533 7534 +4361 111 7538 7536 7537 +4362 111 7541 7539 7540 +4363 111 7544 7542 7543 +4364 111 7547 7545 7546 +4365 111 7550 7548 7549 +4366 111 7553 7551 7552 +4367 111 7556 7554 7555 +4368 111 7559 7557 7558 +4369 111 7562 7560 7561 +4370 111 7565 7563 7564 +4371 111 7568 7566 7567 +4372 111 7571 7569 7570 +4373 111 7574 7572 7573 +4374 111 7577 7575 7576 +4375 111 7580 7578 7579 +4376 111 7583 7581 7582 +4377 111 7586 7584 7585 +4378 111 7589 7587 7588 +4379 111 7592 7590 7591 +4380 111 7595 7593 7594 +4381 111 7598 7596 7597 +4382 111 7601 7599 7600 +4383 111 7604 7602 7603 +4384 111 7607 7605 7606 +4385 111 7610 7608 7609 +4386 111 7613 7611 7612 +4387 111 7616 7614 7615 +4388 111 7619 7617 7618 +4389 111 7622 7620 7621 +4390 111 7625 7623 7624 +4391 111 7628 7626 7627 +4392 111 7631 7629 7630 +4393 111 7634 7632 7633 +4394 111 7637 7635 7636 +4395 111 7640 7638 7639 +4396 111 7643 7641 7642 +4397 111 7646 7644 7645 +4398 111 7649 7647 7648 +4399 111 7652 7650 7651 +4400 111 7655 7653 7654 +4401 111 7658 7656 7657 +4402 111 7661 7659 7660 +4403 111 7664 7662 7663 +4404 111 7667 7665 7666 +4405 111 7670 7668 7669 +4406 111 7673 7671 7672 +4407 111 7676 7674 7675 +4408 111 7679 7677 7678 +4409 111 7682 7680 7681 +4410 111 7685 7683 7684 +4411 111 7688 7686 7687 +4412 111 7691 7689 7690 +4413 111 7694 7692 7693 +4414 111 7697 7695 7696 +4415 111 7700 7698 7699 +4416 111 7703 7701 7702 +4417 111 7706 7704 7705 +4418 111 7709 7707 7708 +4419 111 7712 7710 7711 +4420 111 7715 7713 7714 +4421 111 7718 7716 7717 +4422 111 7721 7719 7720 +4423 111 7724 7722 7723 +4424 111 7727 7725 7726 +4425 111 7730 7728 7729 +4426 111 7733 7731 7732 +4427 111 7736 7734 7735 +4428 111 7739 7737 7738 +4429 111 7742 7740 7741 +4430 111 7745 7743 7744 +4431 111 7748 7746 7747 +4432 111 7751 7749 7750 +4433 111 7754 7752 7753 +4434 111 7757 7755 7756 +4435 111 7760 7758 7759 +4436 111 7763 7761 7762 +4437 111 7766 7764 7765 +4438 111 7769 7767 7768 +4439 111 7772 7770 7771 +4440 111 7775 7773 7774 +4441 111 7778 7776 7777 +4442 111 7781 7779 7780 +4443 111 7784 7782 7783 +4444 111 7787 7785 7786 +4445 111 7790 7788 7789 +4446 111 7793 7791 7792 +4447 111 7796 7794 7795 +4448 111 7799 7797 7798 +4449 111 7802 7800 7801 +4450 111 7805 7803 7804 +4451 111 7808 7806 7807 +4452 111 7811 7809 7810 +4453 111 7814 7812 7813 +4454 111 7817 7815 7816 +4455 111 7820 7818 7819 +4456 111 7823 7821 7822 +4457 111 7826 7824 7825 +4458 111 7829 7827 7828 +4459 111 7832 7830 7831 +4460 111 7835 7833 7834 +4461 111 7838 7836 7837 +4462 111 7841 7839 7840 +4463 111 7844 7842 7843 +4464 111 7847 7845 7846 +4465 111 7850 7848 7849 +4466 111 7853 7851 7852 +4467 111 7856 7854 7855 +4468 111 7859 7857 7858 +4469 111 7862 7860 7861 +4470 111 7865 7863 7864 +4471 111 7868 7866 7867 +4472 111 7871 7869 7870 +4473 111 7874 7872 7873 +4474 111 7877 7875 7876 +4475 111 7880 7878 7879 +4476 111 7883 7881 7882 +4477 111 7886 7884 7885 +4478 111 7889 7887 7888 +4479 111 7892 7890 7891 +4480 111 7895 7893 7894 +4481 111 7898 7896 7897 +4482 111 7901 7899 7900 +4483 111 7904 7902 7903 +4484 111 7907 7905 7906 +4485 111 7910 7908 7909 +4486 111 7913 7911 7912 +4487 111 7916 7914 7915 +4488 111 7919 7917 7918 +4489 111 7922 7920 7921 +4490 111 7925 7923 7924 +4491 111 7928 7926 7927 +4492 111 7931 7929 7930 +4493 111 7934 7932 7933 +4494 111 7937 7935 7936 +4495 111 7940 7938 7939 +4496 111 7943 7941 7942 +4497 111 7946 7944 7945 +4498 111 7949 7947 7948 +4499 111 7952 7950 7951 +4500 111 7955 7953 7954 +4501 111 7958 7956 7957 +4502 111 7961 7959 7960 +4503 111 7964 7962 7963 +4504 111 7967 7965 7966 +4505 111 7970 7968 7969 +4506 111 7973 7971 7972 +4507 111 7976 7974 7975 +4508 111 7979 7977 7978 +4509 111 7982 7980 7981 +4510 111 7985 7983 7984 +4511 111 7988 7986 7987 +4512 111 7991 7989 7990 +4513 111 7994 7992 7993 +4514 111 7997 7995 7996 +4515 111 8000 7998 7999 +4516 111 8003 8001 8002 +4517 111 8006 8004 8005 +4518 111 8009 8007 8008 +4519 111 8012 8010 8011 +4520 111 8015 8013 8014 +4521 111 8018 8016 8017 +4522 111 8021 8019 8020 +4523 111 8024 8022 8023 +4524 111 8027 8025 8026 +4525 111 8030 8028 8029 +4526 111 8033 8031 8032 +4527 111 8036 8034 8035 +4528 111 8039 8037 8038 +4529 111 8042 8040 8041 +4530 111 8045 8043 8044 +4531 111 8048 8046 8047 +4532 111 8051 8049 8050 +4533 111 8054 8052 8053 +4534 111 8057 8055 8056 +4535 111 8060 8058 8059 +4536 111 8063 8061 8062 +4537 111 8066 8064 8065 +4538 111 8069 8067 8068 +4539 111 8072 8070 8071 +4540 111 8075 8073 8074 +4541 111 8078 8076 8077 +4542 111 8081 8079 8080 +4543 111 8084 8082 8083 +4544 111 8087 8085 8086 +4545 111 8090 8088 8089 +4546 111 8093 8091 8092 +4547 111 8096 8094 8095 +4548 111 8099 8097 8098 +4549 111 8102 8100 8101 +4550 111 8105 8103 8104 +4551 111 8108 8106 8107 +4552 111 8111 8109 8110 +4553 111 8114 8112 8113 +4554 111 8117 8115 8116 +4555 111 8120 8118 8119 +4556 111 8123 8121 8122 +4557 111 8126 8124 8125 +4558 111 8129 8127 8128 +4559 111 8132 8130 8131 +4560 111 8135 8133 8134 +4561 111 8138 8136 8137 +4562 111 8141 8139 8140 +4563 111 8144 8142 8143 +4564 111 8147 8145 8146 +4565 111 8150 8148 8149 +4566 111 8153 8151 8152 +4567 111 8156 8154 8155 +4568 111 8159 8157 8158 +4569 111 8162 8160 8161 +4570 111 8165 8163 8164 +4571 111 8168 8166 8167 +4572 111 8171 8169 8170 +4573 111 8174 8172 8173 +4574 111 8177 8175 8176 +4575 111 8180 8178 8179 +4576 111 8183 8181 8182 +4577 111 8186 8184 8185 +4578 111 8189 8187 8188 +4579 111 8192 8190 8191 +4580 111 8195 8193 8194 +4581 111 8198 8196 8197 +4582 111 8201 8199 8200 +4583 111 8204 8202 8203 +4584 111 8207 8205 8206 +4585 111 8210 8208 8209 +4586 111 8213 8211 8212 +4587 111 8216 8214 8215 +4588 111 8219 8217 8218 +4589 111 8222 8220 8221 +4590 111 8225 8223 8224 +4591 111 8228 8226 8227 +4592 111 8231 8229 8230 +4593 111 8234 8232 8233 +4594 111 8237 8235 8236 +4595 111 8240 8238 8239 +4596 111 8243 8241 8242 +4597 111 8246 8244 8245 +4598 111 8249 8247 8248 +4599 111 8252 8250 8251 +4600 111 8255 8253 8254 +4601 111 8258 8256 8257 +4602 111 8261 8259 8260 +4603 111 8264 8262 8263 +4604 111 8267 8265 8266 +4605 111 8270 8268 8269 +4606 111 8273 8271 8272 +4607 111 8276 8274 8275 +4608 111 8279 8277 8278 +4609 111 8282 8280 8281 +4610 111 8285 8283 8284 +4611 111 8288 8286 8287 +4612 111 8291 8289 8290 +4613 111 8294 8292 8293 +4614 111 8297 8295 8296 +4615 111 8300 8298 8299 +4616 111 8303 8301 8302 +4617 111 8306 8304 8305 +4618 111 8309 8307 8308 +4619 111 8312 8310 8311 +4620 111 8315 8313 8314 +4621 111 8318 8316 8317 +4622 111 8321 8319 8320 +4623 111 8324 8322 8323 +4624 111 8327 8325 8326 +4625 111 8330 8328 8329 +4626 111 8333 8331 8332 +4627 111 8336 8334 8335 +4628 111 8339 8337 8338 +4629 111 8342 8340 8341 +4630 111 8345 8343 8344 +4631 111 8348 8346 8347 +4632 111 8351 8349 8350 +4633 111 8354 8352 8353 +4634 111 8357 8355 8356 +4635 111 8360 8358 8359 +4636 111 8363 8361 8362 +4637 111 8366 8364 8365 +4638 111 8369 8367 8368 +4639 111 8372 8370 8371 +4640 111 8375 8373 8374 +4641 111 8378 8376 8377 +4642 111 8381 8379 8380 +4643 111 8384 8382 8383 +4644 111 8387 8385 8386 +4645 111 8390 8388 8389 +4646 111 8393 8391 8392 +4647 111 8396 8394 8395 +4648 111 8399 8397 8398 +4649 111 8402 8400 8401 +4650 111 8405 8403 8404 +4651 111 8408 8406 8407 +4652 111 8411 8409 8410 +4653 111 8414 8412 8413 +4654 111 8417 8415 8416 +4655 111 8420 8418 8419 +4656 111 8423 8421 8422 +4657 111 8426 8424 8425 +4658 111 8429 8427 8428 +4659 111 8432 8430 8431 +4660 111 8435 8433 8434 +4661 111 8438 8436 8437 +4662 111 8441 8439 8440 +4663 111 8444 8442 8443 +4664 111 8447 8445 8446 +4665 111 8450 8448 8449 +4666 111 8453 8451 8452 +4667 111 8456 8454 8455 +4668 111 8459 8457 8458 +4669 111 8462 8460 8461 +4670 111 8465 8463 8464 +4671 111 8468 8466 8467 +4672 111 8471 8469 8470 +4673 111 8474 8472 8473 +4674 111 8477 8475 8476 +4675 111 8480 8478 8479 +4676 111 8483 8481 8482 +4677 111 8486 8484 8485 +4678 111 8489 8487 8488 +4679 111 8492 8490 8491 +4680 111 8495 8493 8494 +4681 111 8498 8496 8497 +4682 111 8501 8499 8500 +4683 111 8504 8502 8503 +4684 111 8507 8505 8506 +4685 111 8510 8508 8509 +4686 111 8513 8511 8512 +4687 111 8516 8514 8515 +4688 111 8519 8517 8518 +4689 111 8522 8520 8521 +4690 111 8525 8523 8524 +4691 111 8528 8526 8527 +4692 111 8531 8529 8530 +4693 111 8534 8532 8533 +4694 111 8537 8535 8536 +4695 111 8540 8538 8539 +4696 111 8543 8541 8542 +4697 111 8546 8544 8545 +4698 111 8549 8547 8548 +4699 111 8552 8550 8551 +4700 111 8555 8553 8554 +4701 111 8558 8556 8557 +4702 111 8561 8559 8560 +4703 111 8564 8562 8563 +4704 111 8567 8565 8566 +4705 111 8570 8568 8569 +4706 111 8573 8571 8572 +4707 111 8576 8574 8575 +4708 111 8579 8577 8578 +4709 111 8582 8580 8581 +4710 111 8585 8583 8584 +4711 111 8588 8586 8587 +4712 111 8591 8589 8590 +4713 111 8594 8592 8593 +4714 111 8597 8595 8596 +4715 111 8600 8598 8599 +4716 111 8603 8601 8602 +4717 111 8606 8604 8605 +4718 111 8609 8607 8608 +4719 111 8612 8610 8611 +4720 111 8615 8613 8614 +4721 111 8618 8616 8617 +4722 111 8621 8619 8620 +4723 111 8624 8622 8623 +4724 111 8627 8625 8626 +4725 111 8630 8628 8629 +4726 111 8633 8631 8632 +4727 111 8636 8634 8635 +4728 111 8639 8637 8638 +4729 111 8642 8640 8641 +4730 111 8645 8643 8644 +4731 111 8648 8646 8647 +4732 111 8651 8649 8650 +4733 111 8654 8652 8653 +4734 111 8657 8655 8656 +4735 111 8660 8658 8659 +4736 111 8663 8661 8662 +4737 111 8666 8664 8665 +4738 111 8669 8667 8668 +4739 111 8672 8670 8671 +4740 111 8675 8673 8674 +4741 111 8678 8676 8677 +4742 111 8681 8679 8680 +4743 111 8684 8682 8683 +4744 111 8687 8685 8686 +4745 111 8690 8688 8689 +4746 111 8693 8691 8692 +4747 111 8696 8694 8695 +4748 111 8699 8697 8698 +4749 111 8702 8700 8701 +4750 111 8705 8703 8704 +4751 111 8708 8706 8707 +4752 111 8711 8709 8710 +4753 111 8714 8712 8713 +4754 111 8717 8715 8716 +4755 111 8720 8718 8719 +4756 111 8723 8721 8722 +4757 111 8726 8724 8725 +4758 111 8729 8727 8728 +4759 111 8732 8730 8731 +4760 111 8735 8733 8734 +4761 111 8738 8736 8737 +4762 111 8741 8739 8740 +4763 111 8744 8742 8743 +4764 111 8747 8745 8746 +4765 111 8750 8748 8749 +4766 111 8753 8751 8752 +4767 111 8756 8754 8755 +4768 111 8759 8757 8758 +4769 111 8762 8760 8761 +4770 111 8765 8763 8764 +4771 111 8768 8766 8767 +4772 111 8771 8769 8770 +4773 111 8774 8772 8773 +4774 111 8777 8775 8776 +4775 111 8780 8778 8779 +4776 111 8783 8781 8782 +4777 111 8786 8784 8785 +4778 111 8789 8787 8788 +4779 111 8792 8790 8791 +4780 111 8795 8793 8794 +4781 111 8798 8796 8797 +4782 111 8801 8799 8800 +4783 111 8804 8802 8803 +4784 111 8807 8805 8806 +4785 111 8810 8808 8809 +4786 111 8813 8811 8812 +4787 111 8816 8814 8815 +4788 111 8819 8817 8818 +4789 111 8822 8820 8821 +4790 111 8825 8823 8824 +4791 111 8828 8826 8827 +4792 111 8831 8829 8830 +4793 111 8834 8832 8833 +4794 111 8837 8835 8836 +4795 111 8840 8838 8839 +4796 111 8843 8841 8842 +4797 111 8846 8844 8845 +4798 111 8849 8847 8848 +4799 111 8852 8850 8851 +4800 111 8855 8853 8854 +4801 111 8858 8856 8857 +4802 111 8861 8859 8860 +4803 111 8864 8862 8863 +4804 111 8867 8865 8866 +4805 111 8870 8868 8869 +4806 111 8873 8871 8872 +4807 111 8876 8874 8875 +4808 111 8879 8877 8878 +4809 111 8882 8880 8881 +4810 111 8885 8883 8884 +4811 111 8888 8886 8887 +4812 111 8891 8889 8890 +4813 111 8894 8892 8893 +4814 111 8897 8895 8896 +4815 111 8900 8898 8899 +4816 111 8903 8901 8902 +4817 111 8906 8904 8905 +4818 111 8909 8907 8908 +4819 111 8912 8910 8911 +4820 111 8915 8913 8914 +4821 111 8918 8916 8917 +4822 111 8921 8919 8920 +4823 111 8924 8922 8923 +4824 111 8927 8925 8926 +4825 111 8930 8928 8929 +4826 111 8933 8931 8932 +4827 111 8936 8934 8935 +4828 111 8939 8937 8938 +4829 111 8942 8940 8941 +4830 111 8945 8943 8944 +4831 111 8948 8946 8947 +4832 111 8951 8949 8950 +4833 111 8954 8952 8953 +4834 111 8957 8955 8956 +4835 111 8960 8958 8959 +4836 111 8963 8961 8962 +4837 111 8966 8964 8965 +4838 111 8969 8967 8968 +4839 111 8972 8970 8971 +4840 111 8975 8973 8974 +4841 111 8978 8976 8977 +4842 111 8981 8979 8980 +4843 111 8984 8982 8983 +4844 111 8987 8985 8986 +4845 111 8990 8988 8989 +4846 111 8993 8991 8992 +4847 111 8996 8994 8995 +4848 111 8999 8997 8998 +4849 111 9002 9000 9001 +4850 111 9005 9003 9004 +4851 111 9008 9006 9007 +4852 111 9011 9009 9010 +4853 111 9014 9012 9013 +4854 111 9017 9015 9016 +4855 111 9020 9018 9019 +4856 111 9023 9021 9022 +4857 111 9026 9024 9025 +4858 111 9029 9027 9028 +4859 111 9032 9030 9031 +4860 111 9035 9033 9034 +4861 111 9038 9036 9037 +4862 111 9041 9039 9040 +4863 111 9044 9042 9043 +4864 111 9047 9045 9046 +4865 111 9050 9048 9049 +4866 111 9053 9051 9052 +4867 111 9056 9054 9055 +4868 111 9059 9057 9058 +4869 111 9062 9060 9061 +4870 111 9065 9063 9064 +4871 111 9068 9066 9067 +4872 111 9071 9069 9070 +4873 111 9074 9072 9073 +4874 111 9077 9075 9076 +4875 111 9080 9078 9079 +4876 111 9083 9081 9082 +4877 111 9086 9084 9085 +4878 111 9089 9087 9088 +4879 111 9092 9090 9091 +4880 111 9095 9093 9094 +4881 111 9098 9096 9097 +4882 111 9101 9099 9100 +4883 111 9104 9102 9103 +4884 111 9107 9105 9106 +4885 111 9110 9108 9109 +4886 111 9113 9111 9112 +4887 111 9116 9114 9115 +4888 111 9119 9117 9118 +4889 111 9122 9120 9121 +4890 111 9125 9123 9124 +4891 111 9128 9126 9127 +4892 111 9131 9129 9130 +4893 111 9134 9132 9133 +4894 111 9137 9135 9136 +4895 111 9140 9138 9139 +4896 111 9143 9141 9142 +4897 111 9146 9144 9145 +4898 111 9149 9147 9148 +4899 111 9152 9150 9151 +4900 111 9155 9153 9154 +4901 111 9158 9156 9157 +4902 111 9161 9159 9160 +4903 111 9164 9162 9163 +4904 111 9167 9165 9166 +4905 111 9170 9168 9169 +4906 111 9173 9171 9172 +4907 111 9176 9174 9175 +4908 111 9179 9177 9178 +4909 111 9182 9180 9181 +4910 111 9185 9183 9184 +4911 111 9188 9186 9187 +4912 111 9191 9189 9190 +4913 111 9194 9192 9193 +4914 111 9197 9195 9196 +4915 111 9200 9198 9199 +4916 111 9203 9201 9202 +4917 111 9206 9204 9205 +4918 111 9209 9207 9208 +4919 111 9212 9210 9211 +4920 111 9215 9213 9214 +4921 111 9218 9216 9217 +4922 111 9221 9219 9220 +4923 111 9224 9222 9223 +4924 111 9227 9225 9226 +4925 111 9230 9228 9229 +4926 111 9233 9231 9232 +4927 111 9236 9234 9235 +4928 111 9239 9237 9238 +4929 111 9242 9240 9241 +4930 111 9245 9243 9244 +4931 111 9248 9246 9247 +4932 111 9251 9249 9250 +4933 111 9254 9252 9253 +4934 111 9257 9255 9256 +4935 111 9260 9258 9259 +4936 111 9263 9261 9262 +4937 111 9266 9264 9265 +4938 111 9269 9267 9268 +4939 111 9272 9270 9271 +4940 111 9275 9273 9274 +4941 111 9278 9276 9277 +4942 111 9281 9279 9280 +4943 111 9284 9282 9283 +4944 111 9287 9285 9286 +4945 111 9290 9288 9289 +4946 111 9293 9291 9292 +4947 111 9296 9294 9295 +4948 111 9299 9297 9298 +4949 111 9302 9300 9301 +4950 111 9305 9303 9304 +4951 111 9308 9306 9307 +4952 111 9311 9309 9310 +4953 111 9314 9312 9313 +4954 111 9317 9315 9316 +4955 111 9320 9318 9319 +4956 111 9323 9321 9322 +4957 111 9326 9324 9325 +4958 111 9329 9327 9328 +4959 111 9332 9330 9331 +4960 111 9335 9333 9334 +4961 111 9338 9336 9337 +4962 111 9341 9339 9340 +4963 111 9344 9342 9343 +4964 111 9347 9345 9346 +4965 111 9350 9348 9349 +4966 111 9353 9351 9352 +4967 111 9356 9354 9355 +4968 111 9359 9357 9358 +4969 111 9362 9360 9361 +4970 111 9365 9363 9364 +4971 111 9368 9366 9367 +4972 111 9371 9369 9370 +4973 111 9374 9372 9373 +4974 111 9377 9375 9376 +4975 111 9380 9378 9379 +4976 111 9383 9381 9382 +4977 111 9386 9384 9385 +4978 111 9389 9387 9388 +4979 111 9392 9390 9391 +4980 111 9395 9393 9394 +4981 111 9398 9396 9397 +4982 111 9401 9399 9400 +4983 111 9404 9402 9403 +4984 111 9407 9405 9406 +4985 111 9410 9408 9409 +4986 111 9413 9411 9412 +4987 111 9416 9414 9415 +4988 111 9419 9417 9418 +4989 111 9422 9420 9421 +4990 111 9425 9423 9424 +4991 111 9428 9426 9427 +4992 111 9431 9429 9430 +4993 111 9434 9432 9433 +4994 111 9437 9435 9436 +4995 111 9440 9438 9439 +4996 111 9443 9441 9442 +4997 111 9446 9444 9445 +4998 111 9449 9447 9448 +4999 111 9452 9450 9451 +5000 111 9455 9453 9454 +5001 111 9458 9456 9457 +5002 111 9461 9459 9460 +5003 111 9464 9462 9463 +5004 111 9467 9465 9466 +5005 111 9470 9468 9469 +5006 111 9473 9471 9472 +5007 111 9476 9474 9475 +5008 111 9479 9477 9478 +5009 111 9482 9480 9481 +5010 111 9485 9483 9484 +5011 111 9488 9486 9487 +5012 111 9491 9489 9490 +5013 111 9494 9492 9493 +5014 111 9497 9495 9496 +5015 111 9500 9498 9499 +5016 111 9503 9501 9502 +5017 111 9506 9504 9505 +5018 111 9509 9507 9508 +5019 111 9512 9510 9511 +5020 111 9515 9513 9514 +5021 111 9518 9516 9517 +5022 111 9521 9519 9520 +5023 111 9524 9522 9523 +5024 111 9527 9525 9526 +5025 111 9530 9528 9529 +5026 111 9533 9531 9532 +5027 111 9536 9534 9535 +5028 111 9539 9537 9538 +5029 111 9542 9540 9541 +5030 111 9545 9543 9544 +5031 111 9548 9546 9547 +5032 111 9551 9549 9550 +5033 111 9554 9552 9553 +5034 111 9557 9555 9556 +5035 111 9560 9558 9559 +5036 111 9563 9561 9562 +5037 111 9566 9564 9565 +5038 111 9569 9567 9568 +5039 111 9572 9570 9571 +5040 111 9575 9573 9574 +5041 111 9578 9576 9577 +5042 111 9581 9579 9580 +5043 111 9584 9582 9583 +5044 111 9587 9585 9586 +5045 111 9590 9588 9589 +5046 111 9593 9591 9592 +5047 111 9596 9594 9595 +5048 111 9599 9597 9598 +5049 111 9602 9600 9601 +5050 111 9605 9603 9604 +5051 111 9608 9606 9607 +5052 111 9611 9609 9610 +5053 111 9614 9612 9613 +5054 111 9617 9615 9616 +5055 111 9620 9618 9619 +5056 111 9623 9621 9622 +5057 111 9626 9624 9625 +5058 111 9629 9627 9628 +5059 111 9632 9630 9631 +5060 111 9635 9633 9634 +5061 111 9638 9636 9637 +5062 111 9641 9639 9640 +5063 111 9644 9642 9643 +5064 111 9647 9645 9646 +5065 111 9650 9648 9649 +5066 111 9653 9651 9652 +5067 111 9656 9654 9655 +5068 111 9659 9657 9658 +5069 111 9662 9660 9661 +5070 111 9665 9663 9664 +5071 111 9668 9666 9667 +5072 111 9671 9669 9670 +5073 111 9674 9672 9673 +5074 111 9677 9675 9676 +5075 111 9680 9678 9679 +5076 111 9683 9681 9682 +5077 111 9686 9684 9685 +5078 111 9689 9687 9688 +5079 111 9692 9690 9691 +5080 111 9695 9693 9694 +5081 111 9698 9696 9697 +5082 111 9701 9699 9700 +5083 111 9704 9702 9703 +5084 111 9707 9705 9706 +5085 111 9710 9708 9709 +5086 111 9713 9711 9712 +5087 111 9716 9714 9715 +5088 111 9719 9717 9718 +5089 111 9722 9720 9721 +5090 111 9725 9723 9724 +5091 111 9728 9726 9727 +5092 111 9731 9729 9730 +5093 111 9734 9732 9733 +5094 111 9737 9735 9736 Dihedrals @@ -25069,6 +25071,660 @@ Dihedrals 3296 189 1231 1226 1227 1228 3297 189 1231 1226 1227 1232 +Impropers + +1 1 2 3 4 20 +2 2 4 3 2 20 +3 3 20 3 2 4 +4 4 3 20 21 24 +5 5 21 20 3 24 +6 6 24 20 3 21 +7 1 21 22 23 37 +8 2 23 22 21 37 +9 3 37 22 21 23 +10 7 27 28 29 30 +11 2 29 28 27 30 +12 3 30 28 27 29 +13 4 28 30 35 36 +14 6 35 30 28 36 +15 6 36 30 28 35 +16 4 22 37 38 41 +17 5 38 37 22 41 +18 6 41 37 22 38 +19 1 38 39 40 56 +20 2 40 39 38 56 +21 3 56 39 38 40 +22 4 39 56 57 60 +23 5 57 56 39 60 +24 6 60 56 39 57 +25 1 57 58 59 76 +26 2 59 58 57 76 +27 3 76 58 57 59 +28 8 62 63 64 65 +29 9 64 63 62 65 +30 9 65 63 62 64 +31 9 63 64 66 71 +32 9 66 64 63 71 +33 10 71 64 63 66 +34 9 63 65 67 72 +35 9 67 65 63 72 +36 10 72 65 63 67 +37 9 64 66 68 73 +38 9 68 66 64 73 +39 10 73 66 64 68 +40 9 65 67 68 74 +41 9 68 67 65 74 +42 10 74 67 65 68 +43 9 66 68 67 75 +44 9 67 68 66 75 +45 10 75 68 66 67 +46 4 58 76 77 80 +47 5 77 76 58 80 +48 6 80 76 58 77 +49 1 77 78 79 92 +50 2 79 78 77 92 +51 3 92 78 77 79 +52 4 78 92 93 96 +53 5 93 92 78 96 +54 6 96 92 78 93 +55 1 93 94 95 114 +56 2 95 94 93 114 +57 3 114 94 93 95 +58 4 94 114 115 118 +59 5 115 114 94 118 +60 6 118 114 94 115 +61 1 115 116 117 128 +62 2 117 116 115 128 +63 3 128 116 115 117 +64 4 116 128 129 132 +65 5 129 128 116 132 +66 6 132 128 116 129 +67 1 129 130 131 147 +68 2 131 130 129 147 +69 3 147 130 129 131 +70 4 130 147 148 151 +71 5 148 147 130 151 +72 6 151 147 130 148 +73 1 148 149 150 161 +74 2 150 149 148 161 +75 3 161 149 148 150 +76 4 149 161 162 165 +77 11 162 161 149 165 +78 6 165 161 149 162 +79 12 162 163 164 168 +80 2 164 163 162 168 +81 3 168 163 162 164 +82 4 163 168 169 172 +83 5 169 168 163 172 +84 6 172 168 163 169 +85 1 169 170 171 190 +86 2 171 170 169 190 +87 3 190 170 169 171 +88 4 170 190 191 194 +89 5 191 190 170 194 +90 6 194 190 170 191 +91 1 191 192 193 204 +92 2 193 192 191 204 +93 3 204 192 191 193 +94 4 192 204 205 208 +95 5 205 204 192 208 +96 6 208 204 192 205 +97 1 205 206 207 223 +98 2 207 206 205 223 +99 3 223 206 205 207 +100 4 206 223 224 227 +101 5 224 223 206 227 +102 6 227 223 206 224 +103 1 224 225 226 237 +104 2 226 225 224 237 +105 3 237 225 224 226 +106 4 225 237 238 241 +107 5 238 237 225 241 +108 6 241 237 225 238 +109 1 238 239 240 256 +110 2 240 239 238 256 +111 3 256 239 238 240 +112 4 239 256 257 260 +113 5 257 256 239 260 +114 6 260 256 239 257 +115 1 257 258 259 271 +116 2 259 258 257 271 +117 3 271 258 257 259 +118 13 263 264 265 266 +119 14 265 264 263 266 +120 14 266 264 263 265 +121 4 258 271 272 275 +122 5 272 271 258 275 +123 6 275 271 258 272 +124 1 272 273 274 287 +125 2 274 273 272 287 +126 3 287 273 272 274 +127 4 273 287 288 291 +128 5 288 287 273 291 +129 6 291 287 273 288 +130 1 288 289 290 302 +131 2 290 289 288 302 +132 15 302 289 288 290 +133 13 294 295 296 297 +134 14 296 295 294 297 +135 14 297 295 294 296 +136 16 289 302 303 309 +137 17 303 302 289 309 +138 18 309 302 289 303 +139 1 303 304 305 316 +140 2 305 304 303 316 +141 3 316 304 303 305 +142 4 304 316 317 320 +143 5 317 316 304 320 +144 6 320 316 304 317 +145 1 317 318 319 327 +146 2 319 318 317 327 +147 3 327 318 317 319 +148 4 318 327 328 331 +149 5 328 327 318 331 +150 6 331 327 318 328 +151 1 328 329 330 339 +152 2 330 329 328 339 +153 3 339 329 328 330 +154 13 333 334 335 336 +155 14 335 334 333 336 +156 14 336 334 333 335 +157 4 329 339 340 343 +158 5 340 339 329 343 +159 6 343 339 329 340 +160 1 340 341 342 353 +161 2 342 341 340 353 +162 3 353 341 340 342 +163 4 341 353 354 357 +164 5 354 353 341 357 +165 6 357 353 341 354 +166 1 354 355 356 372 +167 2 356 355 354 372 +168 3 372 355 354 356 +169 4 355 372 373 376 +170 5 373 372 355 376 +171 6 376 372 355 373 +172 1 373 374 375 387 +173 2 375 374 373 387 +174 3 387 374 373 375 +175 13 379 380 381 382 +176 14 381 380 379 382 +177 14 382 380 379 381 +178 4 374 387 388 391 +179 5 388 387 374 391 +180 6 391 387 374 388 +181 1 388 389 390 401 +182 2 390 389 388 401 +183 3 401 389 388 390 +184 7 393 394 395 396 +185 2 395 394 393 396 +186 3 396 394 393 395 +187 4 394 396 399 400 +188 6 399 396 394 400 +189 6 400 396 394 399 +190 4 389 401 402 405 +191 5 402 401 389 405 +192 6 405 401 389 402 +193 1 402 403 404 417 +194 2 404 403 402 417 +195 3 417 403 402 404 +196 4 403 417 418 421 +197 5 418 417 403 421 +198 6 421 417 403 418 +199 1 418 419 420 439 +200 2 420 419 418 439 +201 3 439 419 418 420 +202 4 419 439 440 443 +203 5 440 439 419 443 +204 6 443 439 419 440 +205 1 440 441 442 449 +206 2 442 441 440 449 +207 3 449 441 440 442 +208 4 441 449 450 453 +209 5 450 449 441 453 +210 6 453 449 441 450 +211 1 450 451 452 471 +212 2 452 451 450 471 +213 3 471 451 450 452 +214 4 451 471 472 475 +215 5 472 471 451 475 +216 6 475 471 451 472 +217 1 472 473 474 490 +218 2 474 473 472 490 +219 3 490 473 472 474 +220 4 473 490 491 494 +221 5 491 490 473 494 +222 6 494 490 473 491 +223 1 491 492 493 507 +224 2 493 492 491 507 +225 3 507 492 491 493 +226 7 497 498 499 500 +227 2 499 498 497 500 +228 3 500 498 497 499 +229 4 498 500 505 506 +230 6 505 500 498 506 +231 6 506 500 498 505 +232 4 492 507 508 511 +233 5 508 507 492 511 +234 6 511 507 492 508 +235 1 508 509 510 519 +236 2 510 509 508 519 +237 3 519 509 508 510 +238 13 513 514 515 516 +239 14 515 514 513 516 +240 14 516 514 513 515 +241 4 509 519 520 523 +242 5 520 519 509 523 +243 6 523 519 509 520 +244 1 520 521 522 541 +245 2 522 521 520 541 +246 3 541 521 520 522 +247 4 521 541 542 545 +248 5 542 541 521 545 +249 6 545 541 521 542 +250 1 542 543 544 556 +251 2 544 543 542 556 +252 3 556 543 542 544 +253 13 548 549 550 551 +254 14 550 549 548 551 +255 14 551 549 548 550 +256 4 543 556 557 560 +257 11 557 556 543 560 +258 6 560 556 543 557 +259 12 557 558 559 563 +260 2 559 558 557 563 +261 3 563 558 557 559 +262 4 558 563 564 567 +263 5 564 563 558 567 +264 6 567 563 558 564 +265 1 564 565 566 582 +266 2 566 565 564 582 +267 15 582 565 564 566 +268 16 565 582 583 589 +269 17 583 582 565 589 +270 18 589 582 565 583 +271 1 583 584 585 596 +272 2 585 584 583 596 +273 15 596 584 583 585 +274 16 584 596 597 603 +275 17 597 596 584 603 +276 18 603 596 584 597 +277 1 597 598 599 610 +278 2 599 598 597 610 +279 3 610 598 597 599 +280 4 598 610 611 614 +281 5 611 610 598 614 +282 6 614 610 598 611 +283 1 611 612 613 622 +284 2 613 612 611 622 +285 3 622 612 611 613 +286 13 616 617 618 619 +287 14 618 617 616 619 +288 14 619 617 616 618 +289 4 612 622 623 626 +290 5 623 622 612 626 +291 6 626 622 612 623 +292 1 623 624 625 639 +293 2 625 624 623 639 +294 3 639 624 623 625 +295 7 629 630 631 632 +296 2 631 630 629 632 +297 3 632 630 629 631 +298 4 630 632 637 638 +299 6 637 632 630 638 +300 6 638 632 630 637 +301 4 624 639 640 643 +302 5 640 639 624 643 +303 6 643 639 624 640 +304 1 640 641 642 656 +305 2 642 641 640 656 +306 3 656 641 640 642 +307 7 646 647 648 649 +308 2 648 647 646 649 +309 3 649 647 646 648 +310 4 647 649 654 655 +311 6 654 649 647 655 +312 6 655 649 647 654 +313 4 641 656 657 660 +314 5 657 656 641 660 +315 6 660 656 641 657 +316 1 657 658 659 680 +317 2 659 658 657 680 +318 3 680 658 657 659 +319 19 664 665 666 675 +320 20 666 665 664 675 +321 21 675 665 664 666 +322 22 665 666 667 668 +323 22 667 666 665 668 +324 22 668 666 665 667 +325 20 666 667 676 677 +326 21 676 667 666 677 +327 21 677 667 666 676 +328 20 666 668 678 679 +329 21 678 668 666 679 +330 21 679 668 666 678 +331 4 658 680 681 684 +332 5 681 680 658 684 +333 6 684 680 658 681 +334 1 681 682 683 699 +335 2 683 682 681 699 +336 3 699 682 681 683 +337 4 682 699 700 703 +338 5 700 699 682 703 +339 6 703 699 682 700 +340 1 700 701 702 718 +341 2 702 701 700 718 +342 3 718 701 700 702 +343 4 701 718 719 722 +344 5 719 718 701 722 +345 6 722 718 701 719 +346 1 719 720 721 738 +347 2 721 720 719 738 +348 3 738 720 719 721 +349 8 724 725 726 727 +350 9 726 725 724 727 +351 9 727 725 724 726 +352 9 725 726 728 733 +353 9 728 726 725 733 +354 10 733 726 725 728 +355 9 725 727 729 734 +356 9 729 727 725 734 +357 10 734 727 725 729 +358 9 726 728 730 735 +359 9 730 728 726 735 +360 10 735 728 726 730 +361 9 727 729 730 736 +362 9 730 729 727 736 +363 10 736 729 727 730 +364 9 728 730 729 737 +365 9 729 730 728 737 +366 10 737 730 728 729 +367 4 720 738 739 742 +368 5 739 738 720 742 +369 6 742 738 720 739 +370 1 739 740 741 748 +371 2 741 740 739 748 +372 3 748 740 739 741 +373 4 740 748 749 752 +374 11 749 748 740 752 +375 6 752 748 740 749 +376 12 749 750 751 755 +377 2 751 750 749 755 +378 3 755 750 749 751 +379 4 750 755 756 759 +380 5 756 755 750 759 +381 6 759 755 750 756 +382 1 756 757 758 777 +383 2 758 757 756 777 +384 3 777 757 756 758 +385 4 757 777 778 781 +386 5 778 777 757 781 +387 6 781 777 757 778 +388 1 778 779 780 794 +389 2 780 779 778 794 +390 3 794 779 778 780 +391 7 784 785 786 787 +392 2 786 785 784 787 +393 3 787 785 784 786 +394 4 785 787 792 793 +395 6 792 787 785 793 +396 6 793 787 785 792 +397 4 779 794 795 798 +398 5 795 794 779 798 +399 6 798 794 779 795 +400 1 795 796 797 813 +401 2 797 796 795 813 +402 3 813 796 795 797 +403 4 796 813 814 817 +404 5 814 813 796 817 +405 6 817 813 796 814 +406 1 814 815 816 828 +407 2 816 815 814 828 +408 3 828 815 814 816 +409 13 820 821 822 823 +410 14 822 821 820 823 +411 14 823 821 820 822 +412 4 815 828 829 832 +413 5 829 828 815 832 +414 6 832 828 815 829 +415 1 829 830 831 840 +416 2 831 830 829 840 +417 3 840 830 829 831 +418 13 834 835 836 837 +419 14 836 835 834 837 +420 14 837 835 834 836 +421 4 830 840 841 844 +422 11 841 840 830 844 +423 6 844 840 830 841 +424 12 841 842 843 847 +425 2 843 842 841 847 +426 3 847 842 841 843 +427 4 842 847 848 851 +428 5 848 847 842 851 +429 6 851 847 842 848 +430 1 848 849 850 871 +431 2 850 849 848 871 +432 3 871 849 848 850 +433 19 855 856 857 866 +434 20 857 856 855 866 +435 21 866 856 855 857 +436 22 856 857 858 859 +437 22 858 857 856 859 +438 22 859 857 856 858 +439 20 857 858 867 868 +440 21 867 858 857 868 +441 21 868 858 857 867 +442 20 857 859 869 870 +443 21 869 859 857 870 +444 21 870 859 857 869 +445 4 849 871 872 875 +446 5 872 871 849 875 +447 6 875 871 849 872 +448 1 872 873 874 885 +449 2 874 873 872 885 +450 3 885 873 872 874 +451 4 873 885 886 889 +452 5 886 885 873 889 +453 6 889 885 873 886 +454 1 886 887 888 904 +455 2 888 887 886 904 +456 3 904 887 886 888 +457 4 887 904 905 908 +458 5 905 904 887 908 +459 6 908 904 887 905 +460 1 905 906 907 915 +461 2 907 906 905 915 +462 3 915 906 905 907 +463 4 906 915 916 919 +464 5 916 915 906 919 +465 6 919 915 906 916 +466 1 916 917 918 927 +467 2 918 917 916 927 +468 3 927 917 916 918 +469 13 921 922 923 924 +470 14 923 922 921 924 +471 14 924 922 921 923 +472 4 917 927 928 931 +473 5 928 927 917 931 +474 6 931 927 917 928 +475 1 928 929 930 948 +476 2 930 929 928 948 +477 3 948 929 928 930 +478 8 933 934 935 936 +479 9 935 934 933 936 +480 9 936 934 933 935 +481 9 934 935 937 943 +482 9 937 935 934 943 +483 10 943 935 934 937 +484 9 934 936 938 944 +485 9 938 936 934 944 +486 10 944 936 934 938 +487 9 935 937 939 945 +488 9 939 937 935 945 +489 10 945 937 935 939 +490 9 936 938 939 946 +491 9 939 938 936 946 +492 10 946 938 936 939 +493 9 937 939 938 940 +494 9 938 939 937 940 +495 23 940 939 937 938 +496 4 929 948 949 952 +497 5 949 948 929 952 +498 6 952 948 929 949 +499 1 949 950 951 962 +500 2 951 950 949 962 +501 3 962 950 949 951 +502 7 954 955 956 957 +503 2 956 955 954 957 +504 3 957 955 954 956 +505 4 955 957 960 961 +506 6 960 957 955 961 +507 6 961 957 955 960 +508 4 950 962 963 966 +509 5 963 962 950 966 +510 6 966 962 950 963 +511 1 963 964 965 981 +512 2 965 964 963 981 +513 3 981 964 963 965 +514 4 964 981 982 985 +515 5 982 981 964 985 +516 6 985 981 964 982 +517 1 982 983 984 998 +518 2 984 983 982 998 +519 3 998 983 982 984 +520 7 988 989 990 991 +521 2 990 989 988 991 +522 3 991 989 988 990 +523 4 989 991 996 997 +524 6 996 991 989 997 +525 6 997 991 989 996 +526 4 983 998 999 1002 +527 5 999 998 983 1002 +528 6 1002 998 983 999 +529 1 999 1000 1001 1020 +530 2 1001 1000 999 1020 +531 3 1020 1000 999 1001 +532 4 1000 1020 1021 1024 +533 5 1021 1020 1000 1024 +534 6 1024 1020 1000 1021 +535 1 1021 1022 1023 1035 +536 2 1023 1022 1021 1035 +537 3 1035 1022 1021 1023 +538 13 1027 1028 1029 1030 +539 14 1029 1028 1027 1030 +540 14 1030 1028 1027 1029 +541 4 1022 1035 1036 1039 +542 5 1036 1035 1022 1039 +543 6 1039 1035 1022 1036 +544 1 1036 1037 1038 1046 +545 2 1038 1037 1036 1046 +546 3 1046 1037 1036 1038 +547 4 1037 1046 1047 1050 +548 5 1047 1046 1037 1050 +549 6 1050 1046 1037 1047 +550 1 1047 1048 1049 1060 +551 2 1049 1048 1047 1060 +552 3 1060 1048 1047 1049 +553 4 1048 1060 1061 1064 +554 5 1061 1060 1048 1064 +555 6 1064 1060 1048 1061 +556 1 1061 1062 1063 1079 +557 2 1063 1062 1061 1079 +558 3 1079 1062 1061 1063 +559 4 1062 1079 1080 1083 +560 5 1080 1079 1062 1083 +561 6 1083 1079 1062 1080 +562 1 1080 1081 1082 1097 +563 2 1082 1081 1080 1097 +564 3 1097 1081 1080 1082 +565 24 1085 1086 1087 1088 +566 25 1087 1086 1085 1088 +567 26 1088 1086 1085 1087 +568 27 1086 1087 1089 1093 +569 28 1089 1087 1086 1093 +570 29 1093 1087 1086 1089 +571 26 1086 1088 1090 1094 +572 25 1090 1088 1086 1094 +573 30 1094 1088 1086 1090 +574 31 1087 1089 1090 1095 +575 31 1090 1089 1087 1095 +576 32 1095 1089 1087 1090 +577 27 1088 1090 1089 1096 +578 28 1089 1090 1088 1096 +579 29 1096 1090 1088 1089 +580 4 1081 1097 1098 1101 +581 5 1098 1097 1081 1101 +582 6 1101 1097 1081 1098 +583 1 1098 1099 1100 1116 +584 2 1100 1099 1098 1116 +585 3 1116 1099 1098 1100 +586 4 1099 1116 1117 1120 +587 5 1117 1116 1099 1120 +588 6 1120 1116 1099 1117 +589 1 1117 1118 1119 1132 +590 2 1119 1118 1117 1132 +591 3 1132 1118 1117 1119 +592 4 1118 1132 1133 1136 +593 5 1133 1132 1118 1136 +594 6 1136 1132 1118 1133 +595 1 1133 1134 1135 1151 +596 2 1135 1134 1133 1151 +597 3 1151 1134 1133 1135 +598 4 1134 1151 1152 1155 +599 5 1152 1151 1134 1155 +600 6 1155 1151 1134 1152 +601 1 1152 1153 1154 1175 +602 2 1154 1153 1152 1175 +603 3 1175 1153 1152 1154 +604 19 1159 1160 1161 1170 +605 20 1161 1160 1159 1170 +606 21 1170 1160 1159 1161 +607 22 1160 1161 1162 1163 +608 22 1162 1161 1160 1163 +609 22 1163 1161 1160 1162 +610 20 1161 1162 1171 1172 +611 21 1171 1162 1161 1172 +612 21 1172 1162 1161 1171 +613 20 1161 1163 1173 1174 +614 21 1173 1163 1161 1174 +615 21 1174 1163 1161 1173 +616 4 1153 1175 1176 1179 +617 5 1176 1175 1153 1179 +618 6 1179 1175 1153 1176 +619 1 1176 1177 1178 1194 +620 2 1178 1177 1176 1194 +621 3 1194 1177 1176 1178 +622 4 1177 1194 1195 1198 +623 5 1195 1194 1177 1198 +624 6 1198 1194 1177 1195 +625 1 1195 1196 1197 1218 +626 2 1197 1196 1195 1218 +627 3 1218 1196 1195 1197 +628 19 1202 1203 1204 1213 +629 20 1204 1203 1202 1213 +630 21 1213 1203 1202 1204 +631 22 1203 1204 1205 1206 +632 22 1205 1204 1203 1206 +633 22 1206 1204 1203 1205 +634 20 1204 1205 1214 1215 +635 21 1214 1205 1204 1215 +636 21 1215 1205 1204 1214 +637 20 1204 1206 1216 1217 +638 21 1216 1206 1204 1217 +639 21 1217 1206 1204 1216 +640 4 1196 1218 1219 1222 +641 11 1219 1218 1196 1222 +642 6 1222 1218 1196 1219 +643 12 1219 1220 1221 1225 +644 2 1221 1220 1219 1225 +645 3 1225 1220 1219 1221 +646 4 1220 1225 1226 1229 +647 11 1226 1225 1220 1229 +648 6 1229 1225 1220 1226 +649 33 1226 1227 1228 1232 +650 14 1228 1227 1226 1232 +651 14 1232 1227 1226 1228 + Bond Coeffs 1 1.448 381.3 -972.315 1446.3185625 @@ -25426,6 +26082,156 @@ Dihedral Coeffs 188 3 -0.0295 1 0.0 0.95 2 180.0 -0.0225 3 0.0 189 3 -0.077 1 0.0 0.022 2 180.0 -0.043 3 0.0 +Improper Coeffs + +1 49.6 +2 54.0 +3 107.9 +4 70.5 +5 41.7 +6 12.9 +7 20.9 +8 14.4 +9 14.4 +10 15.1 +11 41.7 +12 49.6 +13 121.6 +14 118.7 +15 49.6 +16 14.4 +17 14.4 +18 14.4 +19 0.7 +20 3.6 +21 12.9 +22 1.4 +23 14.4 +24 14.4 +25 14.4 +26 14.4 +27 15.1 +28 15.1 +29 12.9 +30 14.4 +31 14.4 +32 14.4 +33 121.6 + +BondAngle Coeffs + +1 4.3 4.3 1.448 1.015 +2 0.0 0.0 0.0 0.0 +3 18.7 18.7 1.509 1.448 +4 11.5 11.5 1.112 1.448 +5 18.7 18.7 1.525 1.448 +6 11.5 11.5 1.509 1.112 +7 18.7 18.7 1.509 1.525 +8 11.5 11.5 1.112 1.525 +9 18.7 18.7 1.2255 1.509 +10 18.7 18.7 1.345 1.509 +11 18.7 18.7 1.345 1.2255 +12 18.7 18.7 1.525 1.525 +13 11.5 11.5 1.525 1.112 +14 11.5 11.5 1.525 1.112 +15 0.0 0.0 0.0 0.0 +16 18.7 18.7 1.525 1.805 +17 11.5 11.5 1.112 1.805 +18 -5.75 -5.75 1.805 1.805 +19 11.5 11.5 1.112 1.805 +20 7.2 7.2 1.345 1.437 +21 4.3 4.3 1.345 1.028 +22 4.3 4.3 1.028 1.437 +23 18.7 18.7 1.437 1.509 +24 11.5 11.5 1.437 1.112 +25 18.7 18.7 1.437 1.525 +26 18.7 18.7 1.509 1.525 +27 11.5 11.5 1.509 1.112 +28 18.7 18.7 1.2255 1.509 +29 18.7 18.7 1.345 1.509 +30 0.0 0.0 0.0 0.0 +31 18.7 18.7 1.437 1.525 +32 18.7 18.7 1.509 1.525 +33 11.5 11.5 1.112 1.525 +34 18.7 18.7 1.525 1.525 +35 18.7 18.7 1.525 1.525 +36 18.7 18.7 1.525 1.499 +37 11.5 11.5 1.112 1.499 +38 18.7 18.7 1.499 1.3887 +39 18.7 18.7 1.3887 1.3887 +40 11.5 11.5 1.3887 1.1 +41 18.7 18.7 1.525 1.525 +42 18.7 18.7 1.525 1.448 +43 11.5 11.5 1.112 1.448 +44 4.3 4.3 1.448 1.015 +45 0.0 0.0 0.0 0.0 +46 18.7 18.7 1.525 1.413 +47 18.7 18.7 1.525 1.413 +48 11.5 11.5 1.112 1.413 +49 12.95 12.95 1.413 0.947 +50 18.7 18.7 1.525 1.525 +51 7.2 7.2 1.437 1.345 +52 4.3 4.3 1.437 1.028 +53 18.7 18.7 1.437 1.509 +54 11.5 11.5 1.437 1.112 +55 11.5 11.5 1.509 1.112 +56 0.0 0.0 0.0 0.0 +57 18.7 18.7 1.509 1.2255 +58 18.7 18.7 1.345 1.509 +59 18.7 18.7 1.525 1.509 +60 11.5 11.5 1.112 1.509 +61 18.7 18.7 1.509 1.2553 +62 18.7 18.7 1.2553 1.2553 +63 18.7 18.7 1.509 1.345 +64 18.7 18.7 1.2255 1.345 +65 7.2 7.2 1.345 1.437 +66 7.2 7.2 1.345 1.437 +67 7.2 7.2 1.437 1.437 +68 18.7 18.7 1.509 1.437 +69 11.5 11.5 1.112 1.437 +70 18.7 18.7 1.437 1.525 +71 18.7 18.7 1.509 1.525 +72 11.5 11.5 1.112 1.525 +73 18.7 18.7 1.525 1.5247 +74 11.5 11.5 1.525 1.112 +75 11.5 11.5 1.112 1.5247 +76 0.0 0.0 0.0 0.0 +77 18.7 18.7 1.5247 1.5247 +78 18.7 18.7 1.437 1.5247 +79 11.5 11.5 1.112 1.437 +80 11.5 11.5 1.112 1.5247 +81 0.0 0.0 0.0 0.0 +82 18.7 18.7 1.525 1.413 +83 11.5 11.5 1.112 1.413 +84 12.95 12.95 1.413 0.947 +85 18.7 18.7 1.525 1.509 +86 18.7 18.7 1.509 1.525 +87 18.7 18.7 1.446 1.525 +88 11.5 11.5 1.446 1.112 +89 7.2 7.2 1.446 1.325 +90 4.3 4.3 1.446 1.028 +91 4.3 4.3 1.028 1.325 +92 18.7 18.7 1.325 1.325 +93 0.0 0.0 0.0 0.0 +94 18.7 18.7 1.3887 1.355 +95 12.95 12.95 1.355 0.947 +96 18.7 18.7 1.525 1.493 +97 11.5 11.5 1.112 1.493 +98 18.7 18.7 1.493 1.373 +99 18.7 18.7 1.493 1.371 +100 18.7 18.7 1.373 1.371 +101 14.4 14.4 1.373 1.352 +102 4.3 4.3 1.03 1.373 +103 4.3 4.3 1.03 1.352 +104 11.5 11.5 1.371 1.081 +105 11.5 11.5 1.373 1.081 +106 18.7 18.7 1.352 1.352 +107 11.5 11.5 1.352 1.081 +108 18.7 18.7 1.437 1.509 +109 11.5 11.5 1.112 1.509 +110 18.7 18.7 1.509 1.2553 +111 0.0 0.0 0.0 0.0 + Tinker Types 1 234 diff --git a/examples/amoeba/in.ubiquitin b/examples/amoeba/in.ubiquitin index 84627a2941..a8b1880108 100644 --- a/examples/amoeba/in.ubiquitin +++ b/examples/amoeba/in.ubiquitin @@ -8,6 +8,7 @@ atom_style amoeba bond_style class2 angle_style amoeba dihedral_style fourier +improper_style amoeba # per-atom properties required by AMOEBA or HIPPO diff --git a/src/AMOEBA/angle_amoeba.cpp b/src/AMOEBA/angle_amoeba.cpp index 57079cdd83..2563cddb45 100644 --- a/src/AMOEBA/angle_amoeba.cpp +++ b/src/AMOEBA/angle_amoeba.cpp @@ -169,8 +169,9 @@ void AngleAmoeba::compute(int eflag, int vflag) f3[1] = a22*dely2 + a12*dely1; f3[2] = a22*delz2 + a12*delz1; - if (eflag) eangle = k2[type]*dtheta2 + k3[type]*dtheta3 + - k4[type]*dtheta4 + k5[type]*dtheta5 + k6[type]*dtheta6; + //if (eflag) eangle = k2[type]*dtheta2 + k3[type]*dtheta3 + + // k4[type]*dtheta4 + k5[type]*dtheta5 + k6[type]*dtheta6; + eangle = 0.0; // force & energy for bond-angle term // bond-stretch cross term in Tinker @@ -216,6 +217,9 @@ void AngleAmoeba::compute(int eflag, int vflag) if (eflag) eangle += ba_k1[type]*dr1*dtheta + ba_k2[type]*dr2*dtheta; + printf("Stretch-Bend: %ld %d %d: eng %g\n", + atom->tag[i1],atom->tag[i2],atom->tag[i3],eangle); + // apply force to each of 3 atoms if (newton_bond || i1 < nlocal) { @@ -445,6 +449,9 @@ void AngleAmoeba::allocate() memory->create(ba_r2,n+1,"angle:ba_r2"); memory->create(setflag,n+1,"angle:setflag"); + memory->create(setflag_a,n+1,"angle:setflag"); + memory->create(setflag_ba,n+1,"angle:setflag"); + for (int i = 1; i <= n; i++) setflag[i] = setflag_a[i] = setflag_ba[i] = 0; } @@ -500,6 +507,7 @@ void AngleAmoeba::coeff(int narg, char **arg) k4[i] = k4_one; k5[i] = k5_one; k6[i] = k6_one; + setflag_a[i] = 1; count++; } } diff --git a/src/AMOEBA/improper_amoeba.cpp b/src/AMOEBA/improper_amoeba.cpp index 9741939241..abdc3bf811 100644 --- a/src/AMOEBA/improper_amoeba.cpp +++ b/src/AMOEBA/improper_amoeba.cpp @@ -272,16 +272,12 @@ void ImproperAmoeba::init_style() Pair *pair = force->pair_match("amoeba",1,0); if (!pair) pair = force->pair_match("hippo",1,0); if (!pair) error->all(FLERR,"Improper amoeba could not find pair amoega"); - int dim; opbend_cubic = *(double *) pair->extract("opbend_cubic",dim); opbend_quartic = *(double *) pair->extract("opbend_quartic",dim); opbend_pentic = *(double *) pair->extract("opbend_pentic",dim); opbend_sextic = *(double *) pair->extract("opbend_sextic",dim); - - printf("OPBEND %g %g %g %g\n", - opbend_cubic,opbend_quartic,opbend_pentic,opbend_sextic); } /* ---------------------------------------------------------------------- @@ -301,9 +297,8 @@ void ImproperAmoeba::read_restart(FILE *fp) { allocate(); - if (comm->me == 0) { + if (comm->me == 0) utils::sfread(FLERR,&k[1],sizeof(double),atom->nimpropertypes,fp,nullptr,error); - } MPI_Bcast(&k[1],atom->nimpropertypes,MPI_DOUBLE,0,world); for (int i = 1; i <= atom->nimpropertypes; i++) setflag[i] = 1; diff --git a/tools/tinker2lmp.py b/tools/tinker2lmp.py index 63a5b6d154..d31be0084d 100644 --- a/tools/tinker2lmp.py +++ b/tools/tinker2lmp.py @@ -36,7 +36,7 @@ def error(txt=""): print " -nopbc" print " -pbc xhi yhi zhi" else: print "ERROR:",txt - sys.exit() + #sys.exit() # read and store values from a Tinker xyz file @@ -251,13 +251,13 @@ class PRMfile: def bondangles(self): params = [] - iline = self.find_section("Stretch Bend Parameters") + iline = self.find_section("Stretch-Bend Parameters") if iline < 0: return params iline += 3 bdict = {} - for m,params in enumerate(self.bondparams): - bdict[(params[0],params[1])] = params[2] + for m,bparams in enumerate(self.bondparams): + bdict[(bparams[0],bparams[1])] = bparams[2] while iline < self.nlines: words = self.lines[iline].split() @@ -271,14 +271,27 @@ class PRMfile: value2 = float(words[5]) lmp1 = value1 lmp2 = value2 - lmp3 = lmp4 = 0.0 - if (class2,class1) in bdict: lmp3 = bdict[(class2,class1)] - if (class1,class2) in bdict: lmp3 = bdict[(class1,class2)] - if (class2,class3) in bdict: lmp4 = bdict[(class2,class3)] - if (class3,class2) in bdict: lmp4 = bdict[(class3,class2)] - if lmp3 == 0.0 or lmp4 == 0.0: - print "Bond in BondAngle term not found",class1,class2,class3 - sys.exit() + + if (class1,class2) in bdict: + lmp3 = bdict[(class1,class2)] + elif (class2,class1) in bdict: + lmp3 = bdict[(class2,class1)] + else: + error("1st bond in BondAngle term not found: %d %d %d" % \ + (class1,class2,class3)) + # NOTE: just for debugging + lmp3 = 0.0 + + if (class2,class3) in bdict: + lmp4 = bdict[(class2,class3)] + elif (class3,class2) in bdict: + lmp4 = bdict[(class3,class2)] + else: + error("2nd bond in BondAngle term not found: %d %d %d" % \ + (class1,class2,class3)) + # NOTE: just for debugging + lmp4 = 0.0 + params.append((class1,class2,class3,lmp1,lmp2,lmp3,lmp4)) iline += 1 return params @@ -301,12 +314,11 @@ class PRMfile: class4 = int(words[4]) if len(words) <= 5: - print "Torsion has no params",class1,class2,class3,class4 - sys.exit() + error("Torsion has no params: %d %d %d %d" % \ + (class1,class2,class3,class4)) if (len(words)-5) % 3: - print "Torsion does not have triplets of params", \ - class1,class2,class3,class4 - sys.exit() + error("Torsion does not have triplets of params: %d %d %d %d" % \ + (class1,class2,class3,class4)) mfourier = (len(words)-5) / 3 oneparams = [class1,class2,class3,class4,mfourier] @@ -603,9 +615,7 @@ for atom1,atom2 in blist: if (c1,c2) in bdict: m,params = bdict[(c1,c2)] elif (c2,c1) in bdict: m,params = bdict[(c2,c1)] - else: - print "Bond not found",atom1,atom2,c1,c2 - sys.exit() + else: error("Bond not found: %d %d: %d %d" % (atom1,atom2,c1,c2)) if not flags[m]: v1,v2,v3,v4 = params[2:] @@ -615,7 +625,6 @@ for atom1,atom2 in blist: # generate atype = LAMMPS type of each angle # generate aparams = LAMMPS params for each angle type -# generate baparams = LAMMPS bond-angle params for each angle type # flags[i] = which LAMMPS angle type (1-N) the Tinker FF file angle I is # 0 = none # Tinker FF file angle entries can have 1, 2, or 3 options @@ -636,12 +645,11 @@ for m,params in enumerate(prm.angleparams): noptions += n flags = noptions*[0] -#baflags = len(baprm)*[0] atype = [] aparams = [] -baparams = [] -for atom1,atom2,atom3 in alist: +for i,one in enumerate(alist): + atom1,atom2,atom3 = one type1 = type[atom1-1] type2 = type[atom2-1] type3 = type[atom3-1] @@ -651,8 +659,19 @@ for atom1,atom2,atom3 in alist: if (c1,c2,c3) in adict or (c3,c2,c1) in adict: if (c1,c2,c3) in adict: m,params = adict[(c1,c2,c3)] - if (c3,c2,c1) in adict: m,params = adict[(c3,c2,c1)] + + # IMPORTANT subtlety + # flip order of 3 atoms in alist if the angle + # matches Angle Bending section of PRM file in reverse order + # necessary b/c BondAngle coeffs will be generated with r1,r2 params + # from Bond Stretching section of PRM file + # since in general r1 != r2, the LAMMPS AngleAmoeba class requires + # the 3 atoms in the angle be in the order that matches r1 and r2 + if (c3,c2,c1) in adict: + m,params = adict[(c3,c2,c1)] + alist[i] = (atom3,atom2,atom1) + # params is a sequence of 1 or 2 or 3 options # which = which of 1,2,3 options this atom triplet matches # for which = 2 or 3, increment m to index correct position in flags @@ -679,7 +698,7 @@ for atom1,atom2,atom3 in alist: print " angle atom classes:",c1,c2,c3 print " Tinker FF file param options:",len(params[3]) print " Nbonds and hydrogen count:",nbonds,hcount - #sys.exit() // NOTE: allow this for now + #sys.exit() NOTE: allow this for now if hcount == 0: which = 1 elif hcount == 1: @@ -702,7 +721,7 @@ for atom1,atom2,atom3 in alist: print " angle atom classes:",c1,c2,c3 print " Tinker FF file param options:",len(params[3]) print " Nbonds and hydrogen count:",nbonds,hcount - #sys.exit() // NOTE: allow this for now + #sys.exit() NOTE: allow this for now if hcount == 0: which = 1 elif hcount == 1: @@ -713,8 +732,7 @@ for atom1,atom2,atom3 in alist: m += 2 else: - print "Angle not found",atom1,atom2,atom3,c1,c2,c3 - sys.exit() + error("Angle not found: %d %d %d: %d %d %d" % (atom1,atom2,atom3,c1,c2,c3)) if not flags[m]: pflag,v1,v2,v3,v4,v5,v6 = params[3][which-1] @@ -722,24 +740,36 @@ for atom1,atom2,atom3 in alist: flags[m] = len(aparams) atype.append(flags[m]) - # NOTE: baparams may need to be flipped if match is 3,2,1 instead of 1,2,3 - - # NOTE: mismatch between angle and bondangle params may not be handled right - # should be a new LAMMPS type if either angle or bondangle params do not match? - #for m,params in enumerate(baprm): - # c1,c2,c3,v1,v2,v3,v4 = params - # if (c1 == class1 and c2 == class2 and c3 == class3) or \ - # (c1 == class3 and c2 == class2 and c3 == class1): - # found += 1 - # if baflags[m]: - # continue - # #atype.append(baflags[m]) - # else: - # baparams.append((v1,v2,v3,v4)) - # baflags[m] = len(baparams) - # #atype.append(baflags[m]) - # break - # if found != 1: print "Not found",atom1,atom2,atom3,class1,class2,class3 +# augment the aparams with bond-angle cross terms from bondangleparams +# generate baparams = LAMMPS bond-angle params for each angle type +# sbdict = dictionary for angle tuples in bongangleparams + +sbdict = {} +for v1,v2,v3,v4,v5,v6,v7 in prm.bondangleparams: + if (v1,v2,v3) in sbdict: continue + sbdict[(v1,v2,v3)] = (v4,v5,v6,v7) + +baparams = [] + +for itype in range(len(aparams)): + iangle = atype.index(itype+1) + atom1,atom2,atom3 = alist[iangle] + type1 = type[atom1-1] + type2 = type[atom2-1] + type3 = type[atom3-1] + c1 = classes[type1-1] + c2 = classes[type2-1] + c3 = classes[type3-1] + + if (c1,c2,c3) in sbdict: + n1,n2,r1,r2 = sbdict[(c1,c2,c3)] + elif (c3,c2,c1) in sbdict: + n1,n2,r1,r2 = sbdict[(c3,c2,c1)] + else: + print "Bond-stretch angle triplet not found: %d %d %d" % (c1,c2,c3) + n1,n2,r1,r2 = 4*[0.0] + + baparams.append((n1,n2,r1,r2)) # generate dtype = LAMMPS type of each dihedral # generate dparams = LAMMPS params for each dihedral type @@ -774,8 +804,8 @@ for atom1,atom2,atom3,atom4 in dlist: if (c1,c2,c3,c4) in ddict: m,params = ddict[(c1,c2,c3,c4)] elif (c4,c3,c2,c1) in ddict: m,params = ddict[(c4,c3,c2,c1)] else: - print "Dihedral not found",atom1,atom2,atom3,atom4,c1,c2,c3,c4 - sys.exit() + error("Dihedral not found: %d %d %d %d: %d %d %d %d" % \ + (atom1,atom2,atom3,atom4,c1,c2,c3,c4)) if not flags[m]: oneparams = params[4:] @@ -948,17 +978,12 @@ if nangles: lines.append(line+'\n') d.sections["Angle Coeffs"] = lines - #lines = [] - #for i,one in enumerate(aparams): - # line = "%d %g %g %g" % (i+1,0.0,0.0,0.0) - # lines.append(line+'\n') - #d.sections["BondBond Coeffs"] = lines - - #lines = [] - #for i,one in enumerate(aparams): - # line = "%d %g %g %g %g" % (i+1,0.0,0.0,0.0,0.0) - # lines.append(line+'\n') - # d.sections["BondAngle Coeffs"] = lines + lines = [] + for i,one in enumerate(baparams): + strone = [str(single) for single in one] + line = "%d %s" % (i+1,' '.join(strone)) + lines.append(line+'\n') + d.sections["BondAngle Coeffs"] = lines lines = [] for i,one in enumerate(alist): From 7bfc2f2b8f0890bb0fab8dd5169756713df5b51b Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Thu, 16 Dec 2021 08:38:23 -0700 Subject: [PATCH 056/585] angle amoeba with cross-term --- examples/amoeba/in.ubiquitin | 1 + src/AMOEBA/angle_amoeba.cpp | 200 ++++++++++++++++++----------------- 2 files changed, 106 insertions(+), 95 deletions(-) diff --git a/examples/amoeba/in.ubiquitin b/examples/amoeba/in.ubiquitin index a8b1880108..914032fd2a 100644 --- a/examples/amoeba/in.ubiquitin +++ b/examples/amoeba/in.ubiquitin @@ -2,6 +2,7 @@ units real boundary p p p +atom_modify sort 0 0.0 atom_style amoeba diff --git a/src/AMOEBA/angle_amoeba.cpp b/src/AMOEBA/angle_amoeba.cpp index 2563cddb45..6a92706d13 100644 --- a/src/AMOEBA/angle_amoeba.cpp +++ b/src/AMOEBA/angle_amoeba.cpp @@ -111,114 +111,124 @@ void AngleAmoeba::compute(int eflag, int vflag) if (tflag && nspecial[i2][0] == 3) { anglep(i1,i2,i3,type,eflag); - continue; + + } else { + + // 1st bond + + delx1 = x[i1][0] - x[i2][0]; + dely1 = x[i1][1] - x[i2][1]; + delz1 = x[i1][2] - x[i2][2]; + + rsq1 = delx1*delx1 + dely1*dely1 + delz1*delz1; + r1 = sqrt(rsq1); + + // 2nd bond + + delx2 = x[i3][0] - x[i2][0]; + dely2 = x[i3][1] - x[i2][1]; + delz2 = x[i3][2] - x[i2][2]; + + rsq2 = delx2*delx2 + dely2*dely2 + delz2*delz2; + r2 = sqrt(rsq2); + + // angle (cos and sin) + + c = delx1*delx2 + dely1*dely2 + delz1*delz2; + c /= r1*r2; + + if (c > 1.0) c = 1.0; + if (c < -1.0) c = -1.0; + + s = sqrt(1.0 - c*c); + if (s < SMALL) s = SMALL; + s = 1.0/s; + + // force & energy for angle term + + dtheta = acos(c) - theta0[type]; + dtheta2 = dtheta*dtheta; + dtheta3 = dtheta2*dtheta; + dtheta4 = dtheta3*dtheta; + dtheta5 = dtheta4*dtheta; + dtheta6 = dtheta5*dtheta; + + de_angle = 2.0*k2[type]*dtheta + 3.0*k3[type]*dtheta2 + + 4.0*k4[type]*dtheta3 + 5.0*k5[type]*dtheta4 + 6.0*k6[type]*dtheta5; + + a = -de_angle*s; + a11 = a*c / rsq1; + a12 = -a / (r1*r2); + a22 = a*c / rsq2; + + f1[0] = a11*delx1 + a12*delx2; + f1[1] = a11*dely1 + a12*dely2; + f1[2] = a11*delz1 + a12*delz2; + + f3[0] = a22*delx2 + a12*delx1; + f3[1] = a22*dely2 + a12*dely1; + f3[2] = a22*delz2 + a12*delz1; + + //if (eflag) eangle = k2[type]*dtheta2 + k3[type]*dtheta3 + + // k4[type]*dtheta4 + k5[type]*dtheta5 + k6[type]*dtheta6; } - // 1st bond - - delx1 = x[i1][0] - x[i2][0]; - dely1 = x[i1][1] - x[i2][1]; - delz1 = x[i1][2] - x[i2][2]; - - rsq1 = delx1*delx1 + dely1*dely1 + delz1*delz1; - r1 = sqrt(rsq1); - - // 2nd bond - - delx2 = x[i3][0] - x[i2][0]; - dely2 = x[i3][1] - x[i2][1]; - delz2 = x[i3][2] - x[i2][2]; - - rsq2 = delx2*delx2 + dely2*dely2 + delz2*delz2; - r2 = sqrt(rsq2); - - // angle (cos and sin) - - c = delx1*delx2 + dely1*dely2 + delz1*delz2; - c /= r1*r2; - - if (c > 1.0) c = 1.0; - if (c < -1.0) c = -1.0; - - s = sqrt(1.0 - c*c); - if (s < SMALL) s = SMALL; - s = 1.0/s; - - // force & energy for angle term - - dtheta = acos(c) - theta0[type]; - dtheta2 = dtheta*dtheta; - dtheta3 = dtheta2*dtheta; - dtheta4 = dtheta3*dtheta; - dtheta5 = dtheta4*dtheta; - dtheta6 = dtheta5*dtheta; - - de_angle = 2.0*k2[type]*dtheta + 3.0*k3[type]*dtheta2 + - 4.0*k4[type]*dtheta3 + 5.0*k5[type]*dtheta4 + 6.0*k6[type]*dtheta5; - - a = -de_angle*s; - a11 = a*c / rsq1; - a12 = -a / (r1*r2); - a22 = a*c / rsq2; - - f1[0] = a11*delx1 + a12*delx2; - f1[1] = a11*dely1 + a12*dely2; - f1[2] = a11*delz1 + a12*delz2; - - f3[0] = a22*delx2 + a12*delx1; - f3[1] = a22*dely2 + a12*dely1; - f3[2] = a22*delz2 + a12*delz1; - - //if (eflag) eangle = k2[type]*dtheta2 + k3[type]*dtheta3 + - // k4[type]*dtheta4 + k5[type]*dtheta5 + k6[type]*dtheta6; - eangle = 0.0; - // force & energy for bond-angle term // bond-stretch cross term in Tinker - dr1 = r1 - ba_r1[type]; - dr2 = r2 - ba_r2[type]; + if (ba_k1[type] > 0.0) { - aa1 = s * dr1 * ba_k1[type]; - aa2 = s * dr2 * ba_k2[type]; - aa11 = aa1 * c / rsq1; - aa12 = -aa1 / (r1 * r2); - aa21 = aa2 * c / rsq1; - aa22 = -aa2 / (r1 * r2); - vx11 = (aa11 * delx1) + (aa12 * delx2); - vx12 = (aa21 * delx1) + (aa22 * delx2); - vy11 = (aa11 * dely1) + (aa12 * dely2); - vy12 = (aa21 * dely1) + (aa22 * dely2); - vz11 = (aa11 * delz1) + (aa12 * delz2); - vz12 = (aa21 * delz1) + (aa22 * delz2); + //NOTE: depends on r1,r2,c,s,rsq1,rsq2,delxyz1,delxyz2,dtheta - aa11 = aa1 * c / rsq2; - aa21 = aa2 * c / rsq2; - vx21 = (aa11 * delx2) + (aa12 * delx1); - vx22 = (aa21 * delx2) + (aa22 * delx1); - vy21 = (aa11 * dely2) + (aa12 * dely1); - vy22 = (aa21 * dely2) + (aa22 * dely1); - vz21 = (aa11 * delz2) + (aa12 * delz1); - vz22 = (aa21 * delz2) + (aa22 * delz1); - b1 = ba_k1[type] * dtheta / r1; - b2 = ba_k2[type] * dtheta / r2; + dr1 = r1 - ba_r1[type]; + dr2 = r2 - ba_r2[type]; - f1[0] -= vx11 + b1*delx1 + vx12; - f1[1] -= vy11 + b1*dely1 + vy12; - f1[2] -= vz11 + b1*delz1 + vz12; + aa1 = s * dr1 * ba_k1[type]; + aa2 = s * dr2 * ba_k2[type]; - f3[0] -= vx21 + b2*delx2 + vx22; - f3[1] -= vy21 + b2*dely2 + vy22; - f3[2] -= vz21 + b2*delz2 + vz22; + aa11 = aa1 * c / rsq1; + aa12 = -aa1 / (r1 * r2); + aa21 = aa2 * c / rsq1; + aa22 = -aa2 / (r1 * r2); - if (eflag) eangle += ba_k1[type]*dr1*dtheta + ba_k2[type]*dr2*dtheta; + vx11 = (aa11 * delx1) + (aa12 * delx2); + vx12 = (aa21 * delx1) + (aa22 * delx2); + vy11 = (aa11 * dely1) + (aa12 * dely2); + vy12 = (aa21 * dely1) + (aa22 * dely2); + vz11 = (aa11 * delz1) + (aa12 * delz2); + vz12 = (aa21 * delz1) + (aa22 * delz2); - printf("Stretch-Bend: %ld %d %d: eng %g\n", - atom->tag[i1],atom->tag[i2],atom->tag[i3],eangle); + aa11 = aa1 * c / rsq2; + aa21 = aa2 * c / rsq2; + + vx21 = (aa11 * delx2) + (aa12 * delx1); + vx22 = (aa21 * delx2) + (aa22 * delx1); + vy21 = (aa11 * dely2) + (aa12 * dely1); + vy22 = (aa21 * dely2) + (aa22 * dely1); + vz21 = (aa11 * delz2) + (aa12 * delz1); + vz22 = (aa21 * delz2) + (aa22 * delz1); + + b1 = ba_k1[type] * dtheta / r1; + b2 = ba_k2[type] * dtheta / r2; + + f1[0] -= vx11 + b1*delx1 + vx12; + f1[1] -= vy11 + b1*dely1 + vy12; + f1[2] -= vz11 + b1*delz1 + vz12; + + f3[0] -= vx21 + b2*delx2 + vx22; + f3[1] -= vy21 + b2*dely2 + vy22; + f3[2] -= vz21 + b2*delz2 + vz22; + + //if (eflag) eangle += ba_k1[type]*dr1*dtheta + ba_k2[type]*dr2*dtheta; + if (eflag) eangle = ba_k1[type]*dr1*dtheta + ba_k2[type]*dr2*dtheta; + + printf("Stretch-Bend: %ld %d %d: eng %g\n", + atom->tag[i1],atom->tag[i2],atom->tag[i3],eangle); + } // apply force to each of 3 atoms @@ -350,8 +360,8 @@ void AngleAmoeba::anglep(int i1, int i2, int i3, int type, int eflag) deddt = 2.0*k2[type]*dtheta + 3.0*k3[type]*dtheta2 + 4.0*k4[type]*dtheta3 + 5.0*k5[type]*dtheta4 + 6.0*k6[type]*dtheta5; - if (eflag) eangle = k2[type]*dtheta2 + k3[type]*dtheta3 + - k4[type]*dtheta4 + k5[type]*dtheta5 + k6[type]*dtheta6; + //if (eflag) eangle = k2[type]*dtheta2 + k3[type]*dtheta3 + + // k4[type]*dtheta4 + k5[type]*dtheta5 + k6[type]*dtheta6; // chain rule terms for first derivative components From 08c5644d68c505830bc2a876e5de2e3b0af139b6 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Mon, 20 Dec 2021 11:35:32 -0700 Subject: [PATCH 057/585] fixed bondangle cross term in angle amoeba potential --- src/AMOEBA/angle_amoeba.cpp | 384 +++++++++++++++++++++--------------- src/AMOEBA/angle_amoeba.h | 4 +- 2 files changed, 233 insertions(+), 155 deletions(-) diff --git a/src/AMOEBA/angle_amoeba.cpp b/src/AMOEBA/angle_amoeba.cpp index 6a92706d13..8b529759fd 100644 --- a/src/AMOEBA/angle_amoeba.cpp +++ b/src/AMOEBA/angle_amoeba.cpp @@ -80,23 +80,17 @@ void AngleAmoeba::compute(int eflag, int vflag) { int i1,i2,i3,n,type,tflag; double delx1,dely1,delz1,delx2,dely2,delz2; - double eangle,f1[3],f3[3]; + double f1[3],f3[3]; double dtheta,dtheta2,dtheta3,dtheta4,dtheta5,dtheta6,de_angle; double dr1,dr2,tk1,tk2,aa1,aa2,aa11,aa12,aa21,aa22; double rsq1,rsq2,r1,r2,c,s,a,a11,a12,a22,b1,b2; double vx11,vx12,vy11,vy12,vz11,vz12,vx21,vx22,vy21,vy22,vz21,vz22; - eangle = 0.0; - ev_init(eflag,vflag); - - double **x = atom->x; - double **f = atom->f; int **anglelist = neighbor->anglelist; int **nspecial = atom->nspecial; - int nanglelist = neighbor->nanglelist; - int nlocal = atom->nlocal; - int newton_bond = force->newton_bond; + + ev_init(eflag,vflag); for (n = 0; n < nanglelist; n++) { i1 = anglelist[n][0]; @@ -105,159 +99,240 @@ void AngleAmoeba::compute(int eflag, int vflag) type = anglelist[n][3]; // tflag = 0 for "angle", 1 for "anglep" in Tinker PRM file - // atom 2 must have 3 bond partners to invoke anglep() variant + // atom 2 must have exactly 3 bond partners to invoke anglep() variant tflag = pflag[type]; - if (tflag && nspecial[i2][0] == 3) { - anglep(i1,i2,i3,type,eflag); + if (tflag && nspecial[i2][0] == 3) + tinker_anglep(i1,i2,i3,type,eflag); + else + tinker_angle(i1,i2,i3,type,eflag); - } else { + // bondangle = bond-stretch cross term in Tinker - // 1st bond - - delx1 = x[i1][0] - x[i2][0]; - dely1 = x[i1][1] - x[i2][1]; - delz1 = x[i1][2] - x[i2][2]; - - rsq1 = delx1*delx1 + dely1*dely1 + delz1*delz1; - r1 = sqrt(rsq1); - - // 2nd bond - - delx2 = x[i3][0] - x[i2][0]; - dely2 = x[i3][1] - x[i2][1]; - delz2 = x[i3][2] - x[i2][2]; - - rsq2 = delx2*delx2 + dely2*dely2 + delz2*delz2; - r2 = sqrt(rsq2); - - // angle (cos and sin) - - c = delx1*delx2 + dely1*dely2 + delz1*delz2; - c /= r1*r2; - - if (c > 1.0) c = 1.0; - if (c < -1.0) c = -1.0; - - s = sqrt(1.0 - c*c); - if (s < SMALL) s = SMALL; - s = 1.0/s; - - // force & energy for angle term - - dtheta = acos(c) - theta0[type]; - dtheta2 = dtheta*dtheta; - dtheta3 = dtheta2*dtheta; - dtheta4 = dtheta3*dtheta; - dtheta5 = dtheta4*dtheta; - dtheta6 = dtheta5*dtheta; - - de_angle = 2.0*k2[type]*dtheta + 3.0*k3[type]*dtheta2 + - 4.0*k4[type]*dtheta3 + 5.0*k5[type]*dtheta4 + 6.0*k6[type]*dtheta5; - - a = -de_angle*s; - a11 = a*c / rsq1; - a12 = -a / (r1*r2); - a22 = a*c / rsq2; - - f1[0] = a11*delx1 + a12*delx2; - f1[1] = a11*dely1 + a12*dely2; - f1[2] = a11*delz1 + a12*delz2; - - f3[0] = a22*delx2 + a12*delx1; - f3[1] = a22*dely2 + a12*dely1; - f3[2] = a22*delz2 + a12*delz1; - - //if (eflag) eangle = k2[type]*dtheta2 + k3[type]*dtheta3 + - // k4[type]*dtheta4 + k5[type]*dtheta5 + k6[type]*dtheta6; - } - - // force & energy for bond-angle term - // bond-stretch cross term in Tinker - - if (ba_k1[type] > 0.0) { - - - - //NOTE: depends on r1,r2,c,s,rsq1,rsq2,delxyz1,delxyz2,dtheta - - - - dr1 = r1 - ba_r1[type]; - dr2 = r2 - ba_r2[type]; - - aa1 = s * dr1 * ba_k1[type]; - aa2 = s * dr2 * ba_k2[type]; - - aa11 = aa1 * c / rsq1; - aa12 = -aa1 / (r1 * r2); - aa21 = aa2 * c / rsq1; - aa22 = -aa2 / (r1 * r2); - - vx11 = (aa11 * delx1) + (aa12 * delx2); - vx12 = (aa21 * delx1) + (aa22 * delx2); - vy11 = (aa11 * dely1) + (aa12 * dely2); - vy12 = (aa21 * dely1) + (aa22 * dely2); - vz11 = (aa11 * delz1) + (aa12 * delz2); - vz12 = (aa21 * delz1) + (aa22 * delz2); - - aa11 = aa1 * c / rsq2; - aa21 = aa2 * c / rsq2; - - vx21 = (aa11 * delx2) + (aa12 * delx1); - vx22 = (aa21 * delx2) + (aa22 * delx1); - vy21 = (aa11 * dely2) + (aa12 * dely1); - vy22 = (aa21 * dely2) + (aa22 * dely1); - vz21 = (aa11 * delz2) + (aa12 * delz1); - vz22 = (aa21 * delz2) + (aa22 * delz1); - - b1 = ba_k1[type] * dtheta / r1; - b2 = ba_k2[type] * dtheta / r2; - - f1[0] -= vx11 + b1*delx1 + vx12; - f1[1] -= vy11 + b1*dely1 + vy12; - f1[2] -= vz11 + b1*delz1 + vz12; - - f3[0] -= vx21 + b2*delx2 + vx22; - f3[1] -= vy21 + b2*dely2 + vy22; - f3[2] -= vz21 + b2*delz2 + vz22; - - //if (eflag) eangle += ba_k1[type]*dr1*dtheta + ba_k2[type]*dr2*dtheta; - if (eflag) eangle = ba_k1[type]*dr1*dtheta + ba_k2[type]*dr2*dtheta; - - printf("Stretch-Bend: %ld %d %d: eng %g\n", - atom->tag[i1],atom->tag[i2],atom->tag[i3],eangle); - } - - // apply force to each of 3 atoms - - if (newton_bond || i1 < nlocal) { - f[i1][0] += f1[0]; - f[i1][1] += f1[1]; - f[i1][2] += f1[2]; - } - - if (newton_bond || i2 < nlocal) { - f[i2][0] -= f1[0] + f3[0]; - f[i2][1] -= f1[1] + f3[1]; - f[i2][2] -= f1[2] + f3[2]; - } - - if (newton_bond || i3 < nlocal) { - f[i3][0] += f3[0]; - f[i3][1] += f3[1]; - f[i3][2] += f3[2]; - } - - if (evflag) ev_tally(i1,i2,i3,nlocal,newton_bond,eangle,f1,f3, - delx1,dely1,delz1,delx2,dely2,delz2); + if (ba_k1[type] != 0.0) + tinker_bondangle(i1,i2,i3,type,eflag); } } /* ---------------------------------------------------------------------- */ -void AngleAmoeba::anglep(int i1, int i2, int i3, int type, int eflag) +void AngleAmoeba::tinker_bondangle(int i1, int i2, int i3, int type, int eflag) +{ + double delx1,dely1,delz1,delx2,dely2,delz2; + double rsq1,r1,rsq2,r2,c,s,dtheta; + double dr1,dr2,aa1,aa2,b1,b2; + double aa11,aa12,aa21,aa22; + double vx11,vx12,vy11,vy12,vz11,vz12,vx21,vx22,vy21,vy22,vz21,vz22; + double eangle,f1[3],f3[3]; + + double **x = atom->x; + double **f = atom->f; + int nlocal = atom->nlocal; + int newton_bond = force->newton_bond; + + // 1st bond + + delx1 = x[i1][0] - x[i2][0]; + dely1 = x[i1][1] - x[i2][1]; + delz1 = x[i1][2] - x[i2][2]; + + rsq1 = delx1*delx1 + dely1*dely1 + delz1*delz1; + r1 = sqrt(rsq1); + + // 2nd bond + + delx2 = x[i3][0] - x[i2][0]; + dely2 = x[i3][1] - x[i2][1]; + delz2 = x[i3][2] - x[i2][2]; + + rsq2 = delx2*delx2 + dely2*dely2 + delz2*delz2; + r2 = sqrt(rsq2); + + // angle (cos and sin) + + c = delx1*delx2 + dely1*dely2 + delz1*delz2; + c /= r1*r2; + + if (c > 1.0) c = 1.0; + if (c < -1.0) c = -1.0; + + s = sqrt(1.0 - c*c); + if (s < SMALL) s = SMALL; + s = 1.0/s; + + dtheta = acos(c) - theta0[type]; + + // force & energy for bond-angle term + + dr1 = r1 - ba_r1[type]; + dr2 = r2 - ba_r2[type]; + + aa1 = s * dr1 * ba_k1[type]; + aa2 = s * dr2 * ba_k2[type]; + + aa11 = aa1 * c / rsq1; + aa12 = -aa1 / (r1 * r2); + aa21 = aa2 * c / rsq1; + aa22 = -aa2 / (r1 * r2); + + vx11 = (aa11 * delx1) + (aa12 * delx2); + vx12 = (aa21 * delx1) + (aa22 * delx2); + vy11 = (aa11 * dely1) + (aa12 * dely2); + vy12 = (aa21 * dely1) + (aa22 * dely2); + vz11 = (aa11 * delz1) + (aa12 * delz2); + vz12 = (aa21 * delz1) + (aa22 * delz2); + + aa11 = aa1 * c / rsq2; + aa21 = aa2 * c / rsq2; + + vx21 = (aa11 * delx2) + (aa12 * delx1); + vx22 = (aa21 * delx2) + (aa22 * delx1); + vy21 = (aa11 * dely2) + (aa12 * dely1); + vy22 = (aa21 * dely2) + (aa22 * dely1); + vz21 = (aa11 * delz2) + (aa12 * delz1); + vz22 = (aa21 * delz2) + (aa22 * delz1); + + b1 = ba_k1[type] * dtheta / r1; + b2 = ba_k2[type] * dtheta / r2; + + f1[0] -= vx11 + b1*delx1 + vx12; + f1[1] -= vy11 + b1*dely1 + vy12; + f1[2] -= vz11 + b1*delz1 + vz12; + + f3[0] -= vx21 + b2*delx2 + vx22; + f3[1] -= vy21 + b2*dely2 + vy22; + f3[2] -= vz21 + b2*delz2 + vz22; + + eangle = 0.0; + if (eflag) eangle = ba_k1[type]*dr1*dtheta + ba_k2[type]*dr2*dtheta; + + // apply force to each of 3 atoms + + if (newton_bond || i1 < nlocal) { + f[i1][0] += f1[0]; + f[i1][1] += f1[1]; + f[i1][2] += f1[2]; + } + + if (newton_bond || i2 < nlocal) { + f[i2][0] -= f1[0] + f3[0]; + f[i2][1] -= f1[1] + f3[1]; + f[i2][2] -= f1[2] + f3[2]; + } + + if (newton_bond || i3 < nlocal) { + f[i3][0] += f3[0]; + f[i3][1] += f3[1]; + f[i3][2] += f3[2]; + } + + if (evflag) ev_tally(i1,i2,i3,nlocal,newton_bond,eangle,f1,f3, + delx1,dely1,delz1,delx2,dely2,delz2); +} + +/* ---------------------------------------------------------------------- */ + +void AngleAmoeba::tinker_angle(int i1, int i2, int i3, int type, int eflag) +{ + double delx1,dely1,delz1,delx2,dely2,delz2; + double eangle,f1[3],f3[3]; + double dtheta,dtheta2,dtheta3,dtheta4,dtheta5,dtheta6,de_angle; + double dr1,dr2,tk1,tk2,aa1,aa2,aa11,aa12,aa21,aa22; + double rsq1,rsq2,r1,r2,c,s,a,a11,a12,a22,b1,b2; + double vx11,vx12,vy11,vy12,vz11,vz12,vx21,vx22,vy21,vy22,vz21,vz22; + + double **x = atom->x; + double **f = atom->f; + int nlocal = atom->nlocal; + int newton_bond = force->newton_bond; + + // 1st bond + + delx1 = x[i1][0] - x[i2][0]; + dely1 = x[i1][1] - x[i2][1]; + delz1 = x[i1][2] - x[i2][2]; + + rsq1 = delx1*delx1 + dely1*dely1 + delz1*delz1; + r1 = sqrt(rsq1); + + // 2nd bond + + delx2 = x[i3][0] - x[i2][0]; + dely2 = x[i3][1] - x[i2][1]; + delz2 = x[i3][2] - x[i2][2]; + + rsq2 = delx2*delx2 + dely2*dely2 + delz2*delz2; + r2 = sqrt(rsq2); + + // angle (cos and sin) + + c = delx1*delx2 + dely1*dely2 + delz1*delz2; + c /= r1*r2; + + if (c > 1.0) c = 1.0; + if (c < -1.0) c = -1.0; + + s = sqrt(1.0 - c*c); + if (s < SMALL) s = SMALL; + s = 1.0/s; + + // force & energy for angle term + + dtheta = acos(c) - theta0[type]; + dtheta2 = dtheta*dtheta; + dtheta3 = dtheta2*dtheta; + dtheta4 = dtheta3*dtheta; + dtheta5 = dtheta4*dtheta; + dtheta6 = dtheta5*dtheta; + + de_angle = 2.0*k2[type]*dtheta + 3.0*k3[type]*dtheta2 + + 4.0*k4[type]*dtheta3 + 5.0*k5[type]*dtheta4 + 6.0*k6[type]*dtheta5; + + a = -de_angle*s; + a11 = a*c / rsq1; + a12 = -a / (r1*r2); + a22 = a*c / rsq2; + + f1[0] = a11*delx1 + a12*delx2; + f1[1] = a11*dely1 + a12*dely2; + f1[2] = a11*delz1 + a12*delz2; + + f3[0] = a22*delx2 + a12*delx1; + f3[1] = a22*dely2 + a12*dely1; + f3[2] = a22*delz2 + a12*delz1; + + eangle = 0.0; + if (eflag) eangle = k2[type]*dtheta2 + k3[type]*dtheta3 + + k4[type]*dtheta4 + k5[type]*dtheta5 + k6[type]*dtheta6; + + // apply force to each of 3 atoms + + if (newton_bond || i1 < nlocal) { + f[i1][0] += f1[0]; + f[i1][1] += f1[1]; + f[i1][2] += f1[2]; + } + + if (newton_bond || i2 < nlocal) { + f[i2][0] -= f1[0] + f3[0]; + f[i2][1] -= f1[1] + f3[1]; + f[i2][2] -= f1[2] + f3[2]; + } + + if (newton_bond || i3 < nlocal) { + f[i3][0] += f3[0]; + f[i3][1] += f3[1]; + f[i3][2] += f3[2]; + } + + if (evflag) ev_tally(i1,i2,i3,nlocal,newton_bond,eangle,f1,f3, + delx1,dely1,delz1,delx2,dely2,delz2); +} + +/* ---------------------------------------------------------------------- */ + +void AngleAmoeba::tinker_anglep(int i1, int i2, int i3, int type, int eflag) { int i4; tagint i1tag,i3tag,i4tag; @@ -360,8 +435,9 @@ void AngleAmoeba::anglep(int i1, int i2, int i3, int type, int eflag) deddt = 2.0*k2[type]*dtheta + 3.0*k3[type]*dtheta2 + 4.0*k4[type]*dtheta3 + 5.0*k5[type]*dtheta4 + 6.0*k6[type]*dtheta5; - //if (eflag) eangle = k2[type]*dtheta2 + k3[type]*dtheta3 + - // k4[type]*dtheta4 + k5[type]*dtheta5 + k6[type]*dtheta6; + eangle = 0.0; + if (eflag) eangle = k2[type]*dtheta2 + k3[type]*dtheta3 + + k4[type]*dtheta4 + k5[type]*dtheta5 + k6[type]*dtheta6; // chain rule terms for first derivative components diff --git a/src/AMOEBA/angle_amoeba.h b/src/AMOEBA/angle_amoeba.h index 0fa50880e9..59160c02bd 100644 --- a/src/AMOEBA/angle_amoeba.h +++ b/src/AMOEBA/angle_amoeba.h @@ -42,7 +42,9 @@ class AngleAmoeba : public Angle { double *ba_k1, *ba_k2, *ba_r1, *ba_r2; int *setflag_a, *setflag_ba; - void anglep(int, int, int, int, int); + void tinker_angle(int, int, int, int, int); + void tinker_anglep(int, int, int, int, int); + void tinker_bondangle(int, int, int, int, int); void allocate(); }; From 6c85c7f7da66d4d57c753b8653333ab22ca2955e Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Mon, 20 Dec 2021 11:50:11 -0700 Subject: [PATCH 058/585] tweak input test script --- examples/amoeba/in.ubiquitin | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/examples/amoeba/in.ubiquitin b/examples/amoeba/in.ubiquitin index 914032fd2a..66ab107f79 100644 --- a/examples/amoeba/in.ubiquitin +++ b/examples/amoeba/in.ubiquitin @@ -4,7 +4,7 @@ units real boundary p p p atom_modify sort 0 0.0 -atom_style amoeba +atom_style amoeba bond_style class2 angle_style amoeba @@ -43,4 +43,4 @@ fix fqxfer all store/state 0 fx fy fz # zero step run -run 0 +run 0 From 75f60fc30aae3269913261d4f94fe7193b12ea89 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Mon, 20 Dec 2021 13:16:36 -0700 Subject: [PATCH 059/585] document improper amoeba better --- src/AMOEBA/improper_amoeba.cpp | 11 +++++++++-- 1 file changed, 9 insertions(+), 2 deletions(-) diff --git a/src/AMOEBA/improper_amoeba.cpp b/src/AMOEBA/improper_amoeba.cpp index abdc3bf811..0f6bb6705c 100644 --- a/src/AMOEBA/improper_amoeba.cpp +++ b/src/AMOEBA/improper_amoeba.cpp @@ -75,6 +75,11 @@ void ImproperAmoeba::compute(int eflag, int vflag) int nlocal = atom->nlocal; int newton_bond = force->newton_bond; + // conversion factors for radians to degrees and vice versa + + double rad2degree = 180.0/MY_PI; + double prefactor = 1.0 / (rad2degree*rad2degree); + for (n = 0; n < nimproperlist; n++) { // in Tinker code, atom1 = D, atom2 = B, atom3 = A, atom4 = C @@ -136,13 +141,15 @@ void ImproperAmoeba::compute(int eflag, int vflag) sine = fabs(ee) / sqrt(cc*rdb2); sine = MIN(1.0,sine); - angle = 180.0/MY_PI * asin(sine); // angle = degrees + // angle needs to be in degrees for Tinker formulas + // b/c opbend_3456 coeffs are in mixed units + + angle = rad2degree * asin(sine); dt = angle; dt2 = dt * dt; dt3 = dt2 * dt; dt4 = dt2 * dt2; - double prefactor = 1.0 / (180.0/MY_PI) / (180.0/MY_PI); e = prefactor * k[type] * dt2 * (1.0 + opbend_cubic*dt + opbend_quartic*dt2 + opbend_pentic*dt3 + opbend_sextic*dt4); eimproper += e; From addb8948f9a922e095d8184c59d6f7ffeab30b27 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Thu, 23 Dec 2021 15:01:41 -0700 Subject: [PATCH 060/585] Able to run dynamics smoothly, does not conserve energy, but maybe that is a feature --- examples/snap/in.grid.pair | 25 +++++-- src/ML-SNAP/pair_sna_grid.cpp | 125 +++++++++++++++++++++++++++++++++- src/compute_grid_local.h | 2 +- src/pair_grid.cpp | 19 ++++-- src/pair_grid.h | 2 +- 5 files changed, 158 insertions(+), 15 deletions(-) diff --git a/examples/snap/in.grid.pair b/examples/snap/in.grid.pair index e2143427e6..99c9623f7d 100644 --- a/examples/snap/in.grid.pair +++ b/examples/snap/in.grid.pair @@ -2,10 +2,14 @@ # Initialize simulation -variable nsteps index 0 +variable dt index 0.5e-5 +variable nthermo index 100 +variable nsteps index 10000 variable nrep index 3 -variable a index 3.316 +variable a index 3.0 variable ngrid index 2 +variable t index 300 +variable del index 0.1 units metal @@ -31,7 +35,7 @@ lattice custom $a & region box block 0 ${nx} 0 ${ny} 0 ${nz} create_box 1 box create_atoms 1 box - +displace_atoms all random ${del} ${del} ${del} 12345 mass 1 180.88 write_dump all custom test.dump id type x y z @@ -56,6 +60,17 @@ pair_style sna/grid grid ${ngrid} ${ngrid} ${ngrid} & pair_coeff * * Al thermo_style custom step temp epair emol etotal press -neighbor 0.0 nsq +thermo ${nthermo} +thermo_modify norm yes -run 10 +# Set up NVE run + +timestep ${dt} +neighbor 1.0 bin +neigh_modify once no every 1 delay 0 check yes + +# Run MD + +velocity all create $t 4928459 loop geom +fix 1 all nve +run ${nsteps} diff --git a/src/ML-SNAP/pair_sna_grid.cpp b/src/ML-SNAP/pair_sna_grid.cpp index 5be3bf98d6..c84dcaf467 100644 --- a/src/ML-SNAP/pair_sna_grid.cpp +++ b/src/ML-SNAP/pair_sna_grid.cpp @@ -85,19 +85,25 @@ void PairSNAGrid::init_list(int /*id*/, NeighList *ptr) void PairSNAGrid::compute(int eflag, int vflag) { + double fij[3]; + ev_init(eflag,vflag); // compute sna for each gridpoint double** const x = atom->x; + double **f = atom->f; const int* const mask = atom->mask; int * const type = atom->type; const int ntotal = atom->nlocal + atom->nghost; - // insure rij, inside, and typej are of size jnum + // insure rij, inside, and typej are of size ntotal snaptr->grow_rij(ntotal); + // first generate fingerprint, + // which allows calculation of beta + for (int iz = nzlo; iz <= nzhi; iz++) for (int iy = nylo; iy <= nyhi; iy++) for (int ix = nxlo; ix <= nxhi; ix++) { @@ -153,6 +159,7 @@ void PairSNAGrid::compute(int eflag, int vflag) snaptr->blist[icoeff]; // quadratic contributions + // untested if (quadraticflag) { int ncount = ncoeff; @@ -167,7 +174,123 @@ void PairSNAGrid::compute(int eflag, int vflag) } } + // this is a proxy for a call to the energy model + // beta is dE/dB^i, the derivative of the total + // energy w.r.t. to descriptors of grid point i + + compute_beta(); + + // second compute forces using beta + + int igrid = 0; + for (int iz = nzlo; iz <= nzhi; iz++) + for (int iy = nylo; iy <= nyhi; iy++) + for (int ix = nxlo; ix <= nxhi; ix++) { + double xgrid[3]; + grid2x(ix, iy, iz, xgrid); + const double xtmp = xgrid[0]; + const double ytmp = xgrid[1]; + const double ztmp = xgrid[2]; + + // currently, all grid points are type 1 + + const int itype = 1; + int ielem = 0; + if (chemflag) + ielem = map[itype]; + const double radi = radelem[itype]; + + // rij[][3] = displacements between atom I and those neighbors + // inside = indices of neighbors of I within cutoff + // typej = types of neighbors of I within cutoff + + int ninside = 0; + for (int j = 0; j < ntotal; j++) { + + const double delx = xtmp - x[j][0]; + const double dely = ytmp - x[j][1]; + const double delz = ztmp - x[j][2]; + const double rsq = delx*delx + dely*dely + delz*delz; + int jtype = type[j]; + int jelem = 0; + if (chemflag) + jelem = map[jtype]; + if (rsq < cutsq[jtype][jtype] && rsq > 1e-20) { + snaptr->rij[ninside][0] = delx; + snaptr->rij[ninside][1] = dely; + snaptr->rij[ninside][2] = delz; + snaptr->inside[ninside] = j; + snaptr->wj[ninside] = wjelem[jtype]; + snaptr->rcutij[ninside] = 2.0*radelem[jtype]*rcutfac; + snaptr->element[ninside] = jelem; // element index for multi-element snap + ninside++; + } + } + + // compute Ui, Yi for atom I + + if (chemflag) + snaptr->compute_ui(ninside, ielem); + else + snaptr->compute_ui(ninside, 0); + + // for neighbors of I within cutoff: + // compute Fij = dEi/dRj = -dEi/dRi + // add to Fi, subtract from Fj + // scaling is that for type I + + snaptr->compute_yi(beta[igrid]); + + for (int jj = 0; jj < ninside; jj++) { + int j = snaptr->inside[jj]; + if (chemflag) + snaptr->compute_duidrj(snaptr->rij[jj], snaptr->wj[jj], + snaptr->rcutij[jj],jj, snaptr->element[jj]); + else + snaptr->compute_duidrj(snaptr->rij[jj], snaptr->wj[jj], + snaptr->rcutij[jj],jj, 0); + + snaptr->compute_deidrj(fij); + + f[j][0] -= fij[0]; + f[j][1] -= fij[1]; + f[j][2] -= fij[2]; + + // tally per-atom virial contribution + + if (vflag) + ev_tally_xyz(-1,j,atom->nlocal,force->newton_pair,0.0,0.0, + fij[0],fij[1],fij[2], + -snaptr->rij[jj][0],-snaptr->rij[jj][1], + -snaptr->rij[jj][2]); + } + + // tally energy contribution + + if (eflag) { + + // get descriptors again + + snaptr->compute_zi(); + snaptr->compute_bi(ielem); + + // evdwl = energy of atom I, sum over coeffs_k * Bi_k + + double evdwl = 0.0; + + // E = beta.B + + for (int icoeff = 0; icoeff < ncoeff; icoeff++) + evdwl += beta[igrid][icoeff]*snaptr->blist[icoeff]; + + ev_tally_full(-1,2.0*evdwl,0.0,0.0,0.0,0.0,0.0); + + } + igrid++; + } + if (vflag_fdotr) virial_fdotr_compute(); + } diff --git a/src/compute_grid_local.h b/src/compute_grid_local.h index 6189e5b27d..b3d2f4cd94 100644 --- a/src/compute_grid_local.h +++ b/src/compute_grid_local.h @@ -34,7 +34,7 @@ class ComputeGridLocal : public Compute { int nxlo, nxhi, nylo, nyhi, nzlo, nzhi; // local grid bounds, inclusive int ngridlocal; // number of local grid points int nvalues; // number of values per grid point - double ****gridlocal; // local grid + double ****gridlocal; // local grid, redundant w.r.t. alocal double **alocal; // pointer to Compute::array_local int triclinic; // triclinic flag double *boxlo, *prd; // box info (units real/ortho or reduced/tri) diff --git a/src/pair_grid.cpp b/src/pair_grid.cpp index 3f88635ecf..1f17553055 100644 --- a/src/pair_grid.cpp +++ b/src/pair_grid.cpp @@ -23,12 +23,14 @@ #include "error.h" #include "comm.h" +#define BETA_CONST 1.0e-2 + using namespace LAMMPS_NS; /* ---------------------------------------------------------------------- */ PairGrid::PairGrid(LAMMPS *lmp) : - Pair(lmp), gridlocal(nullptr), alocal(nullptr) + Pair(lmp), gridlocal(nullptr), alocal(nullptr), beta(nullptr) { single_enable = 0; restartinfo = 0; @@ -50,9 +52,6 @@ PairGrid::PairGrid(LAMMPS *lmp) : PairGrid::~PairGrid() { if (copymode) return; - - memory->destroy(beta); - deallocate_grid(); } @@ -91,6 +90,7 @@ void PairGrid::allocate_grid() memory->create4d_offset(gridlocal,ndesc,nzlo,nzhi,nylo,nyhi, nxlo,nxhi,"pair/grid:gridlocal"); memory->create(alocal, ngridlocal, ndesc, "pair/grid:alocal"); + memory->create(beta, ngridlocal, ndesc-ndesc_base, "pair/grid:beta"); } } @@ -104,6 +104,7 @@ void PairGrid::deallocate_grid() gridlocal_allocated = 0; memory->destroy4d_offset(gridlocal,nzlo,nylo,nxlo); memory->destroy(alocal); + memory->destroy(beta); } } @@ -234,17 +235,21 @@ void PairGrid::copy_gridlocal_to_local_array() } /* ---------------------------------------------------------------------- - get beta from someplace + calculate beta ------------------------------------------------------------------------- */ + // this is a proxy for a call to the energy model + // beta is dE/dB^i, the derivative of the total + // energy w.r.t. to descriptors of grid point i + void PairGrid::compute_beta() { int igrid = 0; for (int iz = nzlo; iz <= nzhi; iz++) for (int iy = nylo; iy <= nyhi; iy++) for (int ix = nxlo; ix <= nxhi; ix++) { - for (int icol = ndesc_base; icol < ndesc; icol++) - beta[igrid][icol] = 1.0; + for (int icol = 0; icol < ndesc-ndesc_base; icol++) + beta[igrid][icol] = BETA_CONST; igrid++; } } diff --git a/src/pair_grid.h b/src/pair_grid.h index 97799a5c30..b5bf7ad9ef 100644 --- a/src/pair_grid.h +++ b/src/pair_grid.h @@ -44,7 +44,7 @@ class PairGrid : public Pair { int nxlo, nxhi, nylo, nyhi, nzlo, nzhi; // local grid bounds, inclusive int ngridlocal; // number of local grid points int nvalues; // number of values per grid point - double ****gridlocal; // local grid + double ****gridlocal; // local grid, redundant w.r.t. alocal double **alocal; // pointer to Compute::array_local int triclinic; // triclinic flag double *boxlo, *prd; // box info (units real/ortho or reduced/tri) From 19d469222a6450d0bf8f90358f50a248ff6a6ee7 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Thu, 23 Dec 2021 16:28:25 -0700 Subject: [PATCH 061/585] Added test for energy conservation --- examples/snap/econs.py | 16 ++++++++++++++++ examples/snap/in.grid.pair | 27 +++++++++++++++++++++------ 2 files changed, 37 insertions(+), 6 deletions(-) create mode 100644 examples/snap/econs.py diff --git a/examples/snap/econs.py b/examples/snap/econs.py new file mode 100644 index 0000000000..2e7167daca --- /dev/null +++ b/examples/snap/econs.py @@ -0,0 +1,16 @@ +import lammps + +infile = "in.grid.pair" +faclist = [0.002, 0.005, 0.01, 0.02, 0.05, 0.1, 0.2, 0.5] + +print("# Timestep DeltaE DeltaE/Timestep^2") +for fac in faclist: + cmdlist = ["-screen","none","-var","dtfac", "%g" % fac] + lmp = lammps.lammps(cmdargs = cmdlist) + lmp.file(infile) + dt = lmp.extract_global("dt", lammps.LAMMPS_DOUBLE) + de = lmp.extract_fix("avede", lammps.LMP_STYLE_GLOBAL, lammps.LMP_TYPE_SCALAR) + dedt2 = de/dt**2 + print(f"{dt} {de} {dedt2}") + + diff --git a/examples/snap/in.grid.pair b/examples/snap/in.grid.pair index 99c9623f7d..e4cf3e3298 100644 --- a/examples/snap/in.grid.pair +++ b/examples/snap/in.grid.pair @@ -1,10 +1,16 @@ # Demonstrate pair style base on sna/grid +# Test energy conservation +# Choose dtfac in the range [0.01,Infinity] +# Large dtfac means small timestep, while +# keeping trajectory output interval fixed +# Variable etotdelta measures change in (PE+KE)/natoms # Initialize simulation -variable dt index 0.5e-5 -variable nthermo index 100 -variable nsteps index 10000 +variable dtfac index 1 +variable dt equal 0.5e-3/${dtfac} +variable nthermo equal 1000*${dtfac} +variable nsteps equal 1000*${dtfac} variable nrep index 3 variable a index 3.0 variable ngrid index 2 @@ -35,8 +41,9 @@ lattice custom $a & region box block 0 ${nx} 0 ${ny} 0 ${nz} create_box 1 box create_atoms 1 box -displace_atoms all random ${del} ${del} ${del} 12345 mass 1 180.88 +displace_atoms all random ${del} ${del} ${del} 12345 +velocity all create $t 4928459 loop geom write_dump all custom test.dump id type x y z @@ -59,7 +66,16 @@ pair_style sna/grid grid ${ngrid} ${ngrid} ${ngrid} & quadraticflag ${quad} switchflag ${switch} pair_coeff * * Al -thermo_style custom step temp epair emol etotal press +thermo ${nthermo} +thermo_modify norm yes + +run 0 + +variable etot0 equal etotal +variable etotdelta equal abs(etotal-${etot0})/atoms +fix avede all ave/time 1 ${nthermo} ${nthermo} v_etotdelta + +thermo_style custom step temp epair ke etotal press v_etotdelta f_avede thermo ${nthermo} thermo_modify norm yes @@ -71,6 +87,5 @@ neigh_modify once no every 1 delay 0 check yes # Run MD -velocity all create $t 4928459 loop geom fix 1 all nve run ${nsteps} From 6de9c09730d9b0e9569d44be0f863fd2cdeb397b Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Thu, 23 Dec 2021 16:35:30 -0700 Subject: [PATCH 062/585] Tweaked econs.py --- examples/snap/econs.py | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/examples/snap/econs.py b/examples/snap/econs.py index 2e7167daca..aece097622 100644 --- a/examples/snap/econs.py +++ b/examples/snap/econs.py @@ -1,7 +1,7 @@ import lammps infile = "in.grid.pair" -faclist = [0.002, 0.005, 0.01, 0.02, 0.05, 0.1, 0.2, 0.5] +faclist = [0.001,0.002, 0.005, 0.01, 0.02, 0.05, 0.1, 0.2, 0.5] print("# Timestep DeltaE DeltaE/Timestep^2") for fac in faclist: From 567c5c733465f891e39e333b877e368f12596b3d Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Thu, 23 Dec 2021 16:37:23 -0700 Subject: [PATCH 063/585] Fixed sign error that now gives wonderful energy conservation --- src/ML-SNAP/pair_sna_grid.cpp | 6 +++--- 1 file changed, 3 insertions(+), 3 deletions(-) diff --git a/src/ML-SNAP/pair_sna_grid.cpp b/src/ML-SNAP/pair_sna_grid.cpp index c84dcaf467..43a07b48e4 100644 --- a/src/ML-SNAP/pair_sna_grid.cpp +++ b/src/ML-SNAP/pair_sna_grid.cpp @@ -252,9 +252,9 @@ void PairSNAGrid::compute(int eflag, int vflag) snaptr->compute_deidrj(fij); - f[j][0] -= fij[0]; - f[j][1] -= fij[1]; - f[j][2] -= fij[2]; + f[j][0] += fij[0]; + f[j][1] += fij[1]; + f[j][2] += fij[2]; // tally per-atom virial contribution From 57aedc500ee7a99fe290f53b3103286427288886 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Thu, 23 Dec 2021 17:40:29 -0700 Subject: [PATCH 064/585] Added a numerical force test, not automated --- examples/snap/in.fnum | 63 +++++++++++++++++++++++++++++++++++++++++++ 1 file changed, 63 insertions(+) create mode 100644 examples/snap/in.fnum diff --git a/examples/snap/in.fnum b/examples/snap/in.fnum new file mode 100644 index 0000000000..addb9827d0 --- /dev/null +++ b/examples/snap/in.fnum @@ -0,0 +1,63 @@ +# Demonstrate pair style base on sna/grid +# Check numerical forces + +variable nrep index 3 +variable a index 3.0 +variable ngrid index 2 +variable del index 0.1 +variable fdelta index 0.0001 + +units metal + +atom_modify map yes + +# generate the box and atom positions using a BCC lattice + +variable nx equal ${nrep} +variable ny equal ${nrep} +variable nz equal ${nrep} + +boundary p p p + +lattice custom $a & + a1 1 0 0 & + a2 0 1 0 & + a3 0 0 1 & + basis 0 0 0 & + basis 0.5 0.5 0.5 & +# origin 0.25 0.25 0.25 +# origin 0.25e-3 0.25e-3 0.25e-3 + +region box block 0 ${nx} 0 ${ny} 0 ${nz} +create_box 1 box +create_atoms 1 box +mass 1 180.88 +displace_atoms all random ${del} ${del} ${del} 12345 + +# define grid compute and atom compute + +group snapgroup type 1 +variable twojmax equal 2 +variable rcutfac equal 4.67637 +variable rfac0 equal 0.99363 +variable rmin0 equal 0 +variable wj equal 1 +variable radelem equal 0.5 +variable bzero equal 0 +variable quad equal 0 +variable switch equal 1 + +pair_style sna/grid grid ${ngrid} ${ngrid} ${ngrid} & + ${rcutfac} ${rfac0} ${twojmax} ${radelem} & + ${wj} rmin0 ${rmin0} bzeroflag ${bzero} & + quadraticflag ${quad} switchflag ${switch} +pair_coeff * * Al + +fix fnum all numdiff 1 ${fdelta} +variable fz1 equal fz[1] +variable fnumz1 equal f_fnum[1][3] +variable ferrz1 equal f_fnum[1][3]-fz[1] +thermo_style custom v_fz1 v_fnumz1 v_ferrz1 +thermo_modify norm yes + +run 0 From 4a7f726395ff720145219a6a0a09d4e5fc6e6ec8 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Thu, 23 Dec 2021 17:40:59 -0700 Subject: [PATCH 065/585] Minor tweak --- examples/snap/in.grid.pair | 3 +-- 1 file changed, 1 insertion(+), 2 deletions(-) diff --git a/examples/snap/in.grid.pair b/examples/snap/in.grid.pair index e4cf3e3298..128da2ad7a 100644 --- a/examples/snap/in.grid.pair +++ b/examples/snap/in.grid.pair @@ -70,7 +70,6 @@ thermo ${nthermo} thermo_modify norm yes run 0 - variable etot0 equal etotal variable etotdelta equal abs(etotal-${etot0})/atoms fix avede all ave/time 1 ${nthermo} ${nthermo} v_etotdelta @@ -87,5 +86,5 @@ neigh_modify once no every 1 delay 0 check yes # Run MD -fix 1 all nve +fix mynve all nve run ${nsteps} From ad307fb7849e408edad0b5aa8bef7614386e683f Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Thu, 30 Dec 2021 11:43:32 -0700 Subject: [PATCH 066/585] Added script for RMSE on numerical forces --- examples/snap/fnum.py | 24 ++++++++++++++++++++++++ 1 file changed, 24 insertions(+) create mode 100644 examples/snap/fnum.py diff --git a/examples/snap/fnum.py b/examples/snap/fnum.py new file mode 100644 index 0000000000..bde45b042c --- /dev/null +++ b/examples/snap/fnum.py @@ -0,0 +1,24 @@ +import lammps + +def sqerr(a,b): + return (a[0]-b[0])**2+(a[1]-b[1])**2+(a[2]-b[2])**2 + +infile = "in.fnum" + +fdeltalist = [1.0e-2,1.0e-3,1.0e-4,1.0e-5,1.0e-6,1.0e-7,1.0e-8,1.0e-9,1.0e-10] + +print("Fdelta RMSE") +for fdelta in fdeltalist: + cmdlist = ["-screen","none","-var","fdelta",f'{fdelta}'] + lmp = lammps.lammps(cmdargs = cmdlist) + lmp.file(infile) + natoms = lmp.get_natoms() + + f = lmp.extract_atom("f") + fnum = lmp.extract_fix("fnum", lammps.LMP_STYLE_ATOM, lammps.LMP_TYPE_ARRAY) + + sumsq = 0 + for i in range(natoms): + sumsq += sqerr(fnum[i],f[i]) + rmse = (sumsq/natoms)**0.5 + print(f"{fdelta} {rmse}") From 0e8287730271cd3256832ab9249d6fa40ac1da43 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Thu, 30 Dec 2021 11:51:16 -0700 Subject: [PATCH 067/585] Tweak --- examples/snap/fnum.py | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/examples/snap/fnum.py b/examples/snap/fnum.py index bde45b042c..9f496861cc 100644 --- a/examples/snap/fnum.py +++ b/examples/snap/fnum.py @@ -18,7 +18,7 @@ for fdelta in fdeltalist: fnum = lmp.extract_fix("fnum", lammps.LMP_STYLE_ATOM, lammps.LMP_TYPE_ARRAY) sumsq = 0 - for i in range(natoms): + for i in range(nlocal): sumsq += sqerr(fnum[i],f[i]) rmse = (sumsq/natoms)**0.5 print(f"{fdelta} {rmse}") From 499bae77bdc3f0ad2521f76a6832c72e55f6b526 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Thu, 30 Dec 2021 12:02:53 -0700 Subject: [PATCH 068/585] Tweak --- examples/snap/fnum.py | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/examples/snap/fnum.py b/examples/snap/fnum.py index 9f496861cc..83bdbba503 100644 --- a/examples/snap/fnum.py +++ b/examples/snap/fnum.py @@ -12,7 +12,7 @@ for fdelta in fdeltalist: cmdlist = ["-screen","none","-var","fdelta",f'{fdelta}'] lmp = lammps.lammps(cmdargs = cmdlist) lmp.file(infile) - natoms = lmp.get_natoms() + nlocal = lmp.extract_global("nlocal") f = lmp.extract_atom("f") fnum = lmp.extract_fix("fnum", lammps.LMP_STYLE_ATOM, lammps.LMP_TYPE_ARRAY) @@ -20,5 +20,5 @@ for fdelta in fdeltalist: sumsq = 0 for i in range(nlocal): sumsq += sqerr(fnum[i],f[i]) - rmse = (sumsq/natoms)**0.5 + rmse = (sumsq/nlocal)**0.5 print(f"{fdelta} {rmse}") From 82b7b2f3ea641daaff87dd2659dc881bbcc585ef Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Tue, 4 Jan 2022 14:02:29 -0700 Subject: [PATCH 069/585] Simplified access of force errors --- examples/snap/fnum.py | 14 ++------------ examples/snap/in.fnum | 8 +++----- 2 files changed, 5 insertions(+), 17 deletions(-) diff --git a/examples/snap/fnum.py b/examples/snap/fnum.py index 83bdbba503..1e50e49b09 100644 --- a/examples/snap/fnum.py +++ b/examples/snap/fnum.py @@ -1,8 +1,5 @@ import lammps -def sqerr(a,b): - return (a[0]-b[0])**2+(a[1]-b[1])**2+(a[2]-b[2])**2 - infile = "in.fnum" fdeltalist = [1.0e-2,1.0e-3,1.0e-4,1.0e-5,1.0e-6,1.0e-7,1.0e-8,1.0e-9,1.0e-10] @@ -12,13 +9,6 @@ for fdelta in fdeltalist: cmdlist = ["-screen","none","-var","fdelta",f'{fdelta}'] lmp = lammps.lammps(cmdargs = cmdlist) lmp.file(infile) - nlocal = lmp.extract_global("nlocal") - - f = lmp.extract_atom("f") - fnum = lmp.extract_fix("fnum", lammps.LMP_STYLE_ATOM, lammps.LMP_TYPE_ARRAY) - - sumsq = 0 - for i in range(nlocal): - sumsq += sqerr(fnum[i],f[i]) - rmse = (sumsq/nlocal)**0.5 + faverrsq = lmp.extract_compute("faverrsq", lammps.LMP_STYLE_GLOBAL, lammps.LMP_TYPE_SCALAR) + rmse = faverrsq**0.5 print(f"{fdelta} {rmse}") diff --git a/examples/snap/in.fnum b/examples/snap/in.fnum index addb9827d0..1298e9aed9 100644 --- a/examples/snap/in.fnum +++ b/examples/snap/in.fnum @@ -54,10 +54,8 @@ pair_style sna/grid grid ${ngrid} ${ngrid} ${ngrid} & pair_coeff * * Al fix fnum all numdiff 1 ${fdelta} -variable fz1 equal fz[1] -variable fnumz1 equal f_fnum[1][3] -variable ferrz1 equal f_fnum[1][3]-fz[1] -thermo_style custom v_fz1 v_fnumz1 v_ferrz1 -thermo_modify norm yes +variable ferrsq atom (fx-f_fnum[1])^2+(fy-f_fnum[2])^2+(fz-f_fnum[3])^2 +compute faverrsq all reduce ave v_ferrsq +thermo_style custom c_faverrsq run 0 From 1f456a447cddbdb250e95108cca24dda80f5f1b3 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Thu, 3 Mar 2022 09:23:33 -0700 Subject: [PATCH 070/585] add support for Urey-Bradley H-H bonds --- examples/amoeba/data.ubiquitin | 12582 +++++++---------------------- tools/tinker/data.py | 376 + tools/{ => tinker}/tinker2lmp.py | 96 +- 3 files changed, 3310 insertions(+), 9744 deletions(-) create mode 100644 tools/tinker/data.py rename tools/{ => tinker}/tinker2lmp.py (92%) diff --git a/examples/amoeba/data.ubiquitin b/examples/amoeba/data.ubiquitin index bf83af9f73..4151ae36a8 100644 --- a/examples/amoeba/data.ubiquitin +++ b/examples/amoeba/data.ubiquitin @@ -1,12 +1,12 @@ -LAMMPS data file created from Tinker ubiquitin2.xyz and amoeba_ubiquitin2.prm files +LAMMPS data file created from Tinker ubiquitin.xyz and amoeba_ubiquitin.prm files 9737 atoms -6908 bonds +9743 bonds 5094 angles 3297 dihedrals 651 impropers 6 atom types -48 bond types +49 bond types 111 angle types 189 dihedral types 33 improper types @@ -16673,6 +16673,2841 @@ Bonds 6906 48 9732 9734 6907 48 9735 9736 6908 48 9735 9737 +6909 49 74 74 +6910 49 74 74 +6911 49 74 74 +6912 49 74 74 +6913 49 74 74 +6914 49 74 74 +6915 49 74 74 +6916 49 74 74 +6917 49 74 74 +6918 49 74 74 +6919 49 74 74 +6920 49 74 74 +6921 49 74 74 +6922 49 74 74 +6923 49 74 74 +6924 49 74 74 +6925 49 74 74 +6926 49 74 74 +6927 49 74 74 +6928 49 74 74 +6929 49 74 74 +6930 49 74 74 +6931 49 74 74 +6932 49 74 74 +6933 49 74 74 +6934 49 74 74 +6935 49 74 74 +6936 49 74 74 +6937 49 74 74 +6938 49 74 74 +6939 49 74 74 +6940 49 74 74 +6941 49 74 74 +6942 49 74 74 +6943 49 74 74 +6944 49 74 74 +6945 49 74 74 +6946 49 74 74 +6947 49 74 74 +6948 49 74 74 +6949 49 74 74 +6950 49 74 74 +6951 49 74 74 +6952 49 74 74 +6953 49 74 74 +6954 49 74 74 +6955 49 74 74 +6956 49 74 74 +6957 49 74 74 +6958 49 74 74 +6959 49 74 74 +6960 49 74 74 +6961 49 74 74 +6962 49 74 74 +6963 49 74 74 +6964 49 74 74 +6965 49 74 74 +6966 49 74 74 +6967 49 74 74 +6968 49 74 74 +6969 49 74 74 +6970 49 74 74 +6971 49 74 74 +6972 49 74 74 +6973 49 74 74 +6974 49 74 74 +6975 49 74 74 +6976 49 74 74 +6977 49 74 74 +6978 49 74 74 +6979 49 74 74 +6980 49 74 74 +6981 49 74 74 +6982 49 74 74 +6983 49 74 74 +6984 49 74 74 +6985 49 74 74 +6986 49 74 74 +6987 49 74 74 +6988 49 74 74 +6989 49 74 74 +6990 49 74 74 +6991 49 74 74 +6992 49 74 74 +6993 49 74 74 +6994 49 74 74 +6995 49 74 74 +6996 49 74 74 +6997 49 74 74 +6998 49 74 74 +6999 49 74 74 +7000 49 74 74 +7001 49 74 74 +7002 49 74 74 +7003 49 74 74 +7004 49 74 74 +7005 49 74 74 +7006 49 74 74 +7007 49 74 74 +7008 49 74 74 +7009 49 74 74 +7010 49 74 74 +7011 49 74 74 +7012 49 74 74 +7013 49 74 74 +7014 49 74 74 +7015 49 74 74 +7016 49 74 74 +7017 49 74 74 +7018 49 74 74 +7019 49 74 74 +7020 49 74 74 +7021 49 74 74 +7022 49 74 74 +7023 49 74 74 +7024 49 74 74 +7025 49 74 74 +7026 49 74 74 +7027 49 74 74 +7028 49 74 74 +7029 49 74 74 +7030 49 74 74 +7031 49 74 74 +7032 49 74 74 +7033 49 74 74 +7034 49 74 74 +7035 49 74 74 +7036 49 74 74 +7037 49 74 74 +7038 49 74 74 +7039 49 74 74 +7040 49 74 74 +7041 49 74 74 +7042 49 74 74 +7043 49 74 74 +7044 49 74 74 +7045 49 74 74 +7046 49 74 74 +7047 49 74 74 +7048 49 74 74 +7049 49 74 74 +7050 49 74 74 +7051 49 74 74 +7052 49 74 74 +7053 49 74 74 +7054 49 74 74 +7055 49 74 74 +7056 49 74 74 +7057 49 74 74 +7058 49 74 74 +7059 49 74 74 +7060 49 74 74 +7061 49 74 74 +7062 49 74 74 +7063 49 74 74 +7064 49 74 74 +7065 49 74 74 +7066 49 74 74 +7067 49 74 74 +7068 49 74 74 +7069 49 74 74 +7070 49 74 74 +7071 49 74 74 +7072 49 74 74 +7073 49 74 74 +7074 49 74 74 +7075 49 74 74 +7076 49 74 74 +7077 49 74 74 +7078 49 74 74 +7079 49 74 74 +7080 49 74 74 +7081 49 74 74 +7082 49 74 74 +7083 49 74 74 +7084 49 74 74 +7085 49 74 74 +7086 49 74 74 +7087 49 74 74 +7088 49 74 74 +7089 49 74 74 +7090 49 74 74 +7091 49 74 74 +7092 49 74 74 +7093 49 74 74 +7094 49 74 74 +7095 49 74 74 +7096 49 74 74 +7097 49 74 74 +7098 49 74 74 +7099 49 74 74 +7100 49 74 74 +7101 49 74 74 +7102 49 74 74 +7103 49 74 74 +7104 49 74 74 +7105 49 74 74 +7106 49 74 74 +7107 49 74 74 +7108 49 74 74 +7109 49 74 74 +7110 49 74 74 +7111 49 74 74 +7112 49 74 74 +7113 49 74 74 +7114 49 74 74 +7115 49 74 74 +7116 49 74 74 +7117 49 74 74 +7118 49 74 74 +7119 49 74 74 +7120 49 74 74 +7121 49 74 74 +7122 49 74 74 +7123 49 74 74 +7124 49 74 74 +7125 49 74 74 +7126 49 74 74 +7127 49 74 74 +7128 49 74 74 +7129 49 74 74 +7130 49 74 74 +7131 49 74 74 +7132 49 74 74 +7133 49 74 74 +7134 49 74 74 +7135 49 74 74 +7136 49 74 74 +7137 49 74 74 +7138 49 74 74 +7139 49 74 74 +7140 49 74 74 +7141 49 74 74 +7142 49 74 74 +7143 49 74 74 +7144 49 74 74 +7145 49 74 74 +7146 49 74 74 +7147 49 74 74 +7148 49 74 74 +7149 49 74 74 +7150 49 74 74 +7151 49 74 74 +7152 49 74 74 +7153 49 74 74 +7154 49 74 74 +7155 49 74 74 +7156 49 74 74 +7157 49 74 74 +7158 49 74 74 +7159 49 74 74 +7160 49 74 74 +7161 49 74 74 +7162 49 74 74 +7163 49 74 74 +7164 49 74 74 +7165 49 74 74 +7166 49 74 74 +7167 49 74 74 +7168 49 74 74 +7169 49 74 74 +7170 49 74 74 +7171 49 74 74 +7172 49 74 74 +7173 49 74 74 +7174 49 74 74 +7175 49 74 74 +7176 49 74 74 +7177 49 74 74 +7178 49 74 74 +7179 49 74 74 +7180 49 74 74 +7181 49 74 74 +7182 49 74 74 +7183 49 74 74 +7184 49 74 74 +7185 49 74 74 +7186 49 74 74 +7187 49 74 74 +7188 49 74 74 +7189 49 74 74 +7190 49 74 74 +7191 49 74 74 +7192 49 74 74 +7193 49 74 74 +7194 49 74 74 +7195 49 74 74 +7196 49 74 74 +7197 49 74 74 +7198 49 74 74 +7199 49 74 74 +7200 49 74 74 +7201 49 74 74 +7202 49 74 74 +7203 49 74 74 +7204 49 74 74 +7205 49 74 74 +7206 49 74 74 +7207 49 74 74 +7208 49 74 74 +7209 49 74 74 +7210 49 74 74 +7211 49 74 74 +7212 49 74 74 +7213 49 74 74 +7214 49 74 74 +7215 49 74 74 +7216 49 74 74 +7217 49 74 74 +7218 49 74 74 +7219 49 74 74 +7220 49 74 74 +7221 49 74 74 +7222 49 74 74 +7223 49 74 74 +7224 49 74 74 +7225 49 74 74 +7226 49 74 74 +7227 49 74 74 +7228 49 74 74 +7229 49 74 74 +7230 49 74 74 +7231 49 74 74 +7232 49 74 74 +7233 49 74 74 +7234 49 74 74 +7235 49 74 74 +7236 49 74 74 +7237 49 74 74 +7238 49 74 74 +7239 49 74 74 +7240 49 74 74 +7241 49 74 74 +7242 49 74 74 +7243 49 74 74 +7244 49 74 74 +7245 49 74 74 +7246 49 74 74 +7247 49 74 74 +7248 49 74 74 +7249 49 74 74 +7250 49 74 74 +7251 49 74 74 +7252 49 74 74 +7253 49 74 74 +7254 49 74 74 +7255 49 74 74 +7256 49 74 74 +7257 49 74 74 +7258 49 74 74 +7259 49 74 74 +7260 49 74 74 +7261 49 74 74 +7262 49 74 74 +7263 49 74 74 +7264 49 74 74 +7265 49 74 74 +7266 49 74 74 +7267 49 74 74 +7268 49 74 74 +7269 49 74 74 +7270 49 74 74 +7271 49 74 74 +7272 49 74 74 +7273 49 74 74 +7274 49 74 74 +7275 49 74 74 +7276 49 74 74 +7277 49 74 74 +7278 49 74 74 +7279 49 74 74 +7280 49 74 74 +7281 49 74 74 +7282 49 74 74 +7283 49 74 74 +7284 49 74 74 +7285 49 74 74 +7286 49 74 74 +7287 49 74 74 +7288 49 74 74 +7289 49 74 74 +7290 49 74 74 +7291 49 74 74 +7292 49 74 74 +7293 49 74 74 +7294 49 74 74 +7295 49 74 74 +7296 49 74 74 +7297 49 74 74 +7298 49 74 74 +7299 49 74 74 +7300 49 74 74 +7301 49 74 74 +7302 49 74 74 +7303 49 74 74 +7304 49 74 74 +7305 49 74 74 +7306 49 74 74 +7307 49 74 74 +7308 49 74 74 +7309 49 74 74 +7310 49 74 74 +7311 49 74 74 +7312 49 74 74 +7313 49 74 74 +7314 49 74 74 +7315 49 74 74 +7316 49 74 74 +7317 49 74 74 +7318 49 74 74 +7319 49 74 74 +7320 49 74 74 +7321 49 74 74 +7322 49 74 74 +7323 49 74 74 +7324 49 74 74 +7325 49 74 74 +7326 49 74 74 +7327 49 74 74 +7328 49 74 74 +7329 49 74 74 +7330 49 74 74 +7331 49 74 74 +7332 49 74 74 +7333 49 74 74 +7334 49 74 74 +7335 49 74 74 +7336 49 74 74 +7337 49 74 74 +7338 49 74 74 +7339 49 74 74 +7340 49 74 74 +7341 49 74 74 +7342 49 74 74 +7343 49 74 74 +7344 49 74 74 +7345 49 74 74 +7346 49 74 74 +7347 49 74 74 +7348 49 74 74 +7349 49 74 74 +7350 49 74 74 +7351 49 74 74 +7352 49 74 74 +7353 49 74 74 +7354 49 74 74 +7355 49 74 74 +7356 49 74 74 +7357 49 74 74 +7358 49 74 74 +7359 49 74 74 +7360 49 74 74 +7361 49 74 74 +7362 49 74 74 +7363 49 74 74 +7364 49 74 74 +7365 49 74 74 +7366 49 74 74 +7367 49 74 74 +7368 49 74 74 +7369 49 74 74 +7370 49 74 74 +7371 49 74 74 +7372 49 74 74 +7373 49 74 74 +7374 49 74 74 +7375 49 74 74 +7376 49 74 74 +7377 49 74 74 +7378 49 74 74 +7379 49 74 74 +7380 49 74 74 +7381 49 74 74 +7382 49 74 74 +7383 49 74 74 +7384 49 74 74 +7385 49 74 74 +7386 49 74 74 +7387 49 74 74 +7388 49 74 74 +7389 49 74 74 +7390 49 74 74 +7391 49 74 74 +7392 49 74 74 +7393 49 74 74 +7394 49 74 74 +7395 49 74 74 +7396 49 74 74 +7397 49 74 74 +7398 49 74 74 +7399 49 74 74 +7400 49 74 74 +7401 49 74 74 +7402 49 74 74 +7403 49 74 74 +7404 49 74 74 +7405 49 74 74 +7406 49 74 74 +7407 49 74 74 +7408 49 74 74 +7409 49 74 74 +7410 49 74 74 +7411 49 74 74 +7412 49 74 74 +7413 49 74 74 +7414 49 74 74 +7415 49 74 74 +7416 49 74 74 +7417 49 74 74 +7418 49 74 74 +7419 49 74 74 +7420 49 74 74 +7421 49 74 74 +7422 49 74 74 +7423 49 74 74 +7424 49 74 74 +7425 49 74 74 +7426 49 74 74 +7427 49 74 74 +7428 49 74 74 +7429 49 74 74 +7430 49 74 74 +7431 49 74 74 +7432 49 74 74 +7433 49 74 74 +7434 49 74 74 +7435 49 74 74 +7436 49 74 74 +7437 49 74 74 +7438 49 74 74 +7439 49 74 74 +7440 49 74 74 +7441 49 74 74 +7442 49 74 74 +7443 49 74 74 +7444 49 74 74 +7445 49 74 74 +7446 49 74 74 +7447 49 74 74 +7448 49 74 74 +7449 49 74 74 +7450 49 74 74 +7451 49 74 74 +7452 49 74 74 +7453 49 74 74 +7454 49 74 74 +7455 49 74 74 +7456 49 74 74 +7457 49 74 74 +7458 49 74 74 +7459 49 74 74 +7460 49 74 74 +7461 49 74 74 +7462 49 74 74 +7463 49 74 74 +7464 49 74 74 +7465 49 74 74 +7466 49 74 74 +7467 49 74 74 +7468 49 74 74 +7469 49 74 74 +7470 49 74 74 +7471 49 74 74 +7472 49 74 74 +7473 49 74 74 +7474 49 74 74 +7475 49 74 74 +7476 49 74 74 +7477 49 74 74 +7478 49 74 74 +7479 49 74 74 +7480 49 74 74 +7481 49 74 74 +7482 49 74 74 +7483 49 74 74 +7484 49 74 74 +7485 49 74 74 +7486 49 74 74 +7487 49 74 74 +7488 49 74 74 +7489 49 74 74 +7490 49 74 74 +7491 49 74 74 +7492 49 74 74 +7493 49 74 74 +7494 49 74 74 +7495 49 74 74 +7496 49 74 74 +7497 49 74 74 +7498 49 74 74 +7499 49 74 74 +7500 49 74 74 +7501 49 74 74 +7502 49 74 74 +7503 49 74 74 +7504 49 74 74 +7505 49 74 74 +7506 49 74 74 +7507 49 74 74 +7508 49 74 74 +7509 49 74 74 +7510 49 74 74 +7511 49 74 74 +7512 49 74 74 +7513 49 74 74 +7514 49 74 74 +7515 49 74 74 +7516 49 74 74 +7517 49 74 74 +7518 49 74 74 +7519 49 74 74 +7520 49 74 74 +7521 49 74 74 +7522 49 74 74 +7523 49 74 74 +7524 49 74 74 +7525 49 74 74 +7526 49 74 74 +7527 49 74 74 +7528 49 74 74 +7529 49 74 74 +7530 49 74 74 +7531 49 74 74 +7532 49 74 74 +7533 49 74 74 +7534 49 74 74 +7535 49 74 74 +7536 49 74 74 +7537 49 74 74 +7538 49 74 74 +7539 49 74 74 +7540 49 74 74 +7541 49 74 74 +7542 49 74 74 +7543 49 74 74 +7544 49 74 74 +7545 49 74 74 +7546 49 74 74 +7547 49 74 74 +7548 49 74 74 +7549 49 74 74 +7550 49 74 74 +7551 49 74 74 +7552 49 74 74 +7553 49 74 74 +7554 49 74 74 +7555 49 74 74 +7556 49 74 74 +7557 49 74 74 +7558 49 74 74 +7559 49 74 74 +7560 49 74 74 +7561 49 74 74 +7562 49 74 74 +7563 49 74 74 +7564 49 74 74 +7565 49 74 74 +7566 49 74 74 +7567 49 74 74 +7568 49 74 74 +7569 49 74 74 +7570 49 74 74 +7571 49 74 74 +7572 49 74 74 +7573 49 74 74 +7574 49 74 74 +7575 49 74 74 +7576 49 74 74 +7577 49 74 74 +7578 49 74 74 +7579 49 74 74 +7580 49 74 74 +7581 49 74 74 +7582 49 74 74 +7583 49 74 74 +7584 49 74 74 +7585 49 74 74 +7586 49 74 74 +7587 49 74 74 +7588 49 74 74 +7589 49 74 74 +7590 49 74 74 +7591 49 74 74 +7592 49 74 74 +7593 49 74 74 +7594 49 74 74 +7595 49 74 74 +7596 49 74 74 +7597 49 74 74 +7598 49 74 74 +7599 49 74 74 +7600 49 74 74 +7601 49 74 74 +7602 49 74 74 +7603 49 74 74 +7604 49 74 74 +7605 49 74 74 +7606 49 74 74 +7607 49 74 74 +7608 49 74 74 +7609 49 74 74 +7610 49 74 74 +7611 49 74 74 +7612 49 74 74 +7613 49 74 74 +7614 49 74 74 +7615 49 74 74 +7616 49 74 74 +7617 49 74 74 +7618 49 74 74 +7619 49 74 74 +7620 49 74 74 +7621 49 74 74 +7622 49 74 74 +7623 49 74 74 +7624 49 74 74 +7625 49 74 74 +7626 49 74 74 +7627 49 74 74 +7628 49 74 74 +7629 49 74 74 +7630 49 74 74 +7631 49 74 74 +7632 49 74 74 +7633 49 74 74 +7634 49 74 74 +7635 49 74 74 +7636 49 74 74 +7637 49 74 74 +7638 49 74 74 +7639 49 74 74 +7640 49 74 74 +7641 49 74 74 +7642 49 74 74 +7643 49 74 74 +7644 49 74 74 +7645 49 74 74 +7646 49 74 74 +7647 49 74 74 +7648 49 74 74 +7649 49 74 74 +7650 49 74 74 +7651 49 74 74 +7652 49 74 74 +7653 49 74 74 +7654 49 74 74 +7655 49 74 74 +7656 49 74 74 +7657 49 74 74 +7658 49 74 74 +7659 49 74 74 +7660 49 74 74 +7661 49 74 74 +7662 49 74 74 +7663 49 74 74 +7664 49 74 74 +7665 49 74 74 +7666 49 74 74 +7667 49 74 74 +7668 49 74 74 +7669 49 74 74 +7670 49 74 74 +7671 49 74 74 +7672 49 74 74 +7673 49 74 74 +7674 49 74 74 +7675 49 74 74 +7676 49 74 74 +7677 49 74 74 +7678 49 74 74 +7679 49 74 74 +7680 49 74 74 +7681 49 74 74 +7682 49 74 74 +7683 49 74 74 +7684 49 74 74 +7685 49 74 74 +7686 49 74 74 +7687 49 74 74 +7688 49 74 74 +7689 49 74 74 +7690 49 74 74 +7691 49 74 74 +7692 49 74 74 +7693 49 74 74 +7694 49 74 74 +7695 49 74 74 +7696 49 74 74 +7697 49 74 74 +7698 49 74 74 +7699 49 74 74 +7700 49 74 74 +7701 49 74 74 +7702 49 74 74 +7703 49 74 74 +7704 49 74 74 +7705 49 74 74 +7706 49 74 74 +7707 49 74 74 +7708 49 74 74 +7709 49 74 74 +7710 49 74 74 +7711 49 74 74 +7712 49 74 74 +7713 49 74 74 +7714 49 74 74 +7715 49 74 74 +7716 49 74 74 +7717 49 74 74 +7718 49 74 74 +7719 49 74 74 +7720 49 74 74 +7721 49 74 74 +7722 49 74 74 +7723 49 74 74 +7724 49 74 74 +7725 49 74 74 +7726 49 74 74 +7727 49 74 74 +7728 49 74 74 +7729 49 74 74 +7730 49 74 74 +7731 49 74 74 +7732 49 74 74 +7733 49 74 74 +7734 49 74 74 +7735 49 74 74 +7736 49 74 74 +7737 49 74 74 +7738 49 74 74 +7739 49 74 74 +7740 49 74 74 +7741 49 74 74 +7742 49 74 74 +7743 49 74 74 +7744 49 74 74 +7745 49 74 74 +7746 49 74 74 +7747 49 74 74 +7748 49 74 74 +7749 49 74 74 +7750 49 74 74 +7751 49 74 74 +7752 49 74 74 +7753 49 74 74 +7754 49 74 74 +7755 49 74 74 +7756 49 74 74 +7757 49 74 74 +7758 49 74 74 +7759 49 74 74 +7760 49 74 74 +7761 49 74 74 +7762 49 74 74 +7763 49 74 74 +7764 49 74 74 +7765 49 74 74 +7766 49 74 74 +7767 49 74 74 +7768 49 74 74 +7769 49 74 74 +7770 49 74 74 +7771 49 74 74 +7772 49 74 74 +7773 49 74 74 +7774 49 74 74 +7775 49 74 74 +7776 49 74 74 +7777 49 74 74 +7778 49 74 74 +7779 49 74 74 +7780 49 74 74 +7781 49 74 74 +7782 49 74 74 +7783 49 74 74 +7784 49 74 74 +7785 49 74 74 +7786 49 74 74 +7787 49 74 74 +7788 49 74 74 +7789 49 74 74 +7790 49 74 74 +7791 49 74 74 +7792 49 74 74 +7793 49 74 74 +7794 49 74 74 +7795 49 74 74 +7796 49 74 74 +7797 49 74 74 +7798 49 74 74 +7799 49 74 74 +7800 49 74 74 +7801 49 74 74 +7802 49 74 74 +7803 49 74 74 +7804 49 74 74 +7805 49 74 74 +7806 49 74 74 +7807 49 74 74 +7808 49 74 74 +7809 49 74 74 +7810 49 74 74 +7811 49 74 74 +7812 49 74 74 +7813 49 74 74 +7814 49 74 74 +7815 49 74 74 +7816 49 74 74 +7817 49 74 74 +7818 49 74 74 +7819 49 74 74 +7820 49 74 74 +7821 49 74 74 +7822 49 74 74 +7823 49 74 74 +7824 49 74 74 +7825 49 74 74 +7826 49 74 74 +7827 49 74 74 +7828 49 74 74 +7829 49 74 74 +7830 49 74 74 +7831 49 74 74 +7832 49 74 74 +7833 49 74 74 +7834 49 74 74 +7835 49 74 74 +7836 49 74 74 +7837 49 74 74 +7838 49 74 74 +7839 49 74 74 +7840 49 74 74 +7841 49 74 74 +7842 49 74 74 +7843 49 74 74 +7844 49 74 74 +7845 49 74 74 +7846 49 74 74 +7847 49 74 74 +7848 49 74 74 +7849 49 74 74 +7850 49 74 74 +7851 49 74 74 +7852 49 74 74 +7853 49 74 74 +7854 49 74 74 +7855 49 74 74 +7856 49 74 74 +7857 49 74 74 +7858 49 74 74 +7859 49 74 74 +7860 49 74 74 +7861 49 74 74 +7862 49 74 74 +7863 49 74 74 +7864 49 74 74 +7865 49 74 74 +7866 49 74 74 +7867 49 74 74 +7868 49 74 74 +7869 49 74 74 +7870 49 74 74 +7871 49 74 74 +7872 49 74 74 +7873 49 74 74 +7874 49 74 74 +7875 49 74 74 +7876 49 74 74 +7877 49 74 74 +7878 49 74 74 +7879 49 74 74 +7880 49 74 74 +7881 49 74 74 +7882 49 74 74 +7883 49 74 74 +7884 49 74 74 +7885 49 74 74 +7886 49 74 74 +7887 49 74 74 +7888 49 74 74 +7889 49 74 74 +7890 49 74 74 +7891 49 74 74 +7892 49 74 74 +7893 49 74 74 +7894 49 74 74 +7895 49 74 74 +7896 49 74 74 +7897 49 74 74 +7898 49 74 74 +7899 49 74 74 +7900 49 74 74 +7901 49 74 74 +7902 49 74 74 +7903 49 74 74 +7904 49 74 74 +7905 49 74 74 +7906 49 74 74 +7907 49 74 74 +7908 49 74 74 +7909 49 74 74 +7910 49 74 74 +7911 49 74 74 +7912 49 74 74 +7913 49 74 74 +7914 49 74 74 +7915 49 74 74 +7916 49 74 74 +7917 49 74 74 +7918 49 74 74 +7919 49 74 74 +7920 49 74 74 +7921 49 74 74 +7922 49 74 74 +7923 49 74 74 +7924 49 74 74 +7925 49 74 74 +7926 49 74 74 +7927 49 74 74 +7928 49 74 74 +7929 49 74 74 +7930 49 74 74 +7931 49 74 74 +7932 49 74 74 +7933 49 74 74 +7934 49 74 74 +7935 49 74 74 +7936 49 74 74 +7937 49 74 74 +7938 49 74 74 +7939 49 74 74 +7940 49 74 74 +7941 49 74 74 +7942 49 74 74 +7943 49 74 74 +7944 49 74 74 +7945 49 74 74 +7946 49 74 74 +7947 49 74 74 +7948 49 74 74 +7949 49 74 74 +7950 49 74 74 +7951 49 74 74 +7952 49 74 74 +7953 49 74 74 +7954 49 74 74 +7955 49 74 74 +7956 49 74 74 +7957 49 74 74 +7958 49 74 74 +7959 49 74 74 +7960 49 74 74 +7961 49 74 74 +7962 49 74 74 +7963 49 74 74 +7964 49 74 74 +7965 49 74 74 +7966 49 74 74 +7967 49 74 74 +7968 49 74 74 +7969 49 74 74 +7970 49 74 74 +7971 49 74 74 +7972 49 74 74 +7973 49 74 74 +7974 49 74 74 +7975 49 74 74 +7976 49 74 74 +7977 49 74 74 +7978 49 74 74 +7979 49 74 74 +7980 49 74 74 +7981 49 74 74 +7982 49 74 74 +7983 49 74 74 +7984 49 74 74 +7985 49 74 74 +7986 49 74 74 +7987 49 74 74 +7988 49 74 74 +7989 49 74 74 +7990 49 74 74 +7991 49 74 74 +7992 49 74 74 +7993 49 74 74 +7994 49 74 74 +7995 49 74 74 +7996 49 74 74 +7997 49 74 74 +7998 49 74 74 +7999 49 74 74 +8000 49 74 74 +8001 49 74 74 +8002 49 74 74 +8003 49 74 74 +8004 49 74 74 +8005 49 74 74 +8006 49 74 74 +8007 49 74 74 +8008 49 74 74 +8009 49 74 74 +8010 49 74 74 +8011 49 74 74 +8012 49 74 74 +8013 49 74 74 +8014 49 74 74 +8015 49 74 74 +8016 49 74 74 +8017 49 74 74 +8018 49 74 74 +8019 49 74 74 +8020 49 74 74 +8021 49 74 74 +8022 49 74 74 +8023 49 74 74 +8024 49 74 74 +8025 49 74 74 +8026 49 74 74 +8027 49 74 74 +8028 49 74 74 +8029 49 74 74 +8030 49 74 74 +8031 49 74 74 +8032 49 74 74 +8033 49 74 74 +8034 49 74 74 +8035 49 74 74 +8036 49 74 74 +8037 49 74 74 +8038 49 74 74 +8039 49 74 74 +8040 49 74 74 +8041 49 74 74 +8042 49 74 74 +8043 49 74 74 +8044 49 74 74 +8045 49 74 74 +8046 49 74 74 +8047 49 74 74 +8048 49 74 74 +8049 49 74 74 +8050 49 74 74 +8051 49 74 74 +8052 49 74 74 +8053 49 74 74 +8054 49 74 74 +8055 49 74 74 +8056 49 74 74 +8057 49 74 74 +8058 49 74 74 +8059 49 74 74 +8060 49 74 74 +8061 49 74 74 +8062 49 74 74 +8063 49 74 74 +8064 49 74 74 +8065 49 74 74 +8066 49 74 74 +8067 49 74 74 +8068 49 74 74 +8069 49 74 74 +8070 49 74 74 +8071 49 74 74 +8072 49 74 74 +8073 49 74 74 +8074 49 74 74 +8075 49 74 74 +8076 49 74 74 +8077 49 74 74 +8078 49 74 74 +8079 49 74 74 +8080 49 74 74 +8081 49 74 74 +8082 49 74 74 +8083 49 74 74 +8084 49 74 74 +8085 49 74 74 +8086 49 74 74 +8087 49 74 74 +8088 49 74 74 +8089 49 74 74 +8090 49 74 74 +8091 49 74 74 +8092 49 74 74 +8093 49 74 74 +8094 49 74 74 +8095 49 74 74 +8096 49 74 74 +8097 49 74 74 +8098 49 74 74 +8099 49 74 74 +8100 49 74 74 +8101 49 74 74 +8102 49 74 74 +8103 49 74 74 +8104 49 74 74 +8105 49 74 74 +8106 49 74 74 +8107 49 74 74 +8108 49 74 74 +8109 49 74 74 +8110 49 74 74 +8111 49 74 74 +8112 49 74 74 +8113 49 74 74 +8114 49 74 74 +8115 49 74 74 +8116 49 74 74 +8117 49 74 74 +8118 49 74 74 +8119 49 74 74 +8120 49 74 74 +8121 49 74 74 +8122 49 74 74 +8123 49 74 74 +8124 49 74 74 +8125 49 74 74 +8126 49 74 74 +8127 49 74 74 +8128 49 74 74 +8129 49 74 74 +8130 49 74 74 +8131 49 74 74 +8132 49 74 74 +8133 49 74 74 +8134 49 74 74 +8135 49 74 74 +8136 49 74 74 +8137 49 74 74 +8138 49 74 74 +8139 49 74 74 +8140 49 74 74 +8141 49 74 74 +8142 49 74 74 +8143 49 74 74 +8144 49 74 74 +8145 49 74 74 +8146 49 74 74 +8147 49 74 74 +8148 49 74 74 +8149 49 74 74 +8150 49 74 74 +8151 49 74 74 +8152 49 74 74 +8153 49 74 74 +8154 49 74 74 +8155 49 74 74 +8156 49 74 74 +8157 49 74 74 +8158 49 74 74 +8159 49 74 74 +8160 49 74 74 +8161 49 74 74 +8162 49 74 74 +8163 49 74 74 +8164 49 74 74 +8165 49 74 74 +8166 49 74 74 +8167 49 74 74 +8168 49 74 74 +8169 49 74 74 +8170 49 74 74 +8171 49 74 74 +8172 49 74 74 +8173 49 74 74 +8174 49 74 74 +8175 49 74 74 +8176 49 74 74 +8177 49 74 74 +8178 49 74 74 +8179 49 74 74 +8180 49 74 74 +8181 49 74 74 +8182 49 74 74 +8183 49 74 74 +8184 49 74 74 +8185 49 74 74 +8186 49 74 74 +8187 49 74 74 +8188 49 74 74 +8189 49 74 74 +8190 49 74 74 +8191 49 74 74 +8192 49 74 74 +8193 49 74 74 +8194 49 74 74 +8195 49 74 74 +8196 49 74 74 +8197 49 74 74 +8198 49 74 74 +8199 49 74 74 +8200 49 74 74 +8201 49 74 74 +8202 49 74 74 +8203 49 74 74 +8204 49 74 74 +8205 49 74 74 +8206 49 74 74 +8207 49 74 74 +8208 49 74 74 +8209 49 74 74 +8210 49 74 74 +8211 49 74 74 +8212 49 74 74 +8213 49 74 74 +8214 49 74 74 +8215 49 74 74 +8216 49 74 74 +8217 49 74 74 +8218 49 74 74 +8219 49 74 74 +8220 49 74 74 +8221 49 74 74 +8222 49 74 74 +8223 49 74 74 +8224 49 74 74 +8225 49 74 74 +8226 49 74 74 +8227 49 74 74 +8228 49 74 74 +8229 49 74 74 +8230 49 74 74 +8231 49 74 74 +8232 49 74 74 +8233 49 74 74 +8234 49 74 74 +8235 49 74 74 +8236 49 74 74 +8237 49 74 74 +8238 49 74 74 +8239 49 74 74 +8240 49 74 74 +8241 49 74 74 +8242 49 74 74 +8243 49 74 74 +8244 49 74 74 +8245 49 74 74 +8246 49 74 74 +8247 49 74 74 +8248 49 74 74 +8249 49 74 74 +8250 49 74 74 +8251 49 74 74 +8252 49 74 74 +8253 49 74 74 +8254 49 74 74 +8255 49 74 74 +8256 49 74 74 +8257 49 74 74 +8258 49 74 74 +8259 49 74 74 +8260 49 74 74 +8261 49 74 74 +8262 49 74 74 +8263 49 74 74 +8264 49 74 74 +8265 49 74 74 +8266 49 74 74 +8267 49 74 74 +8268 49 74 74 +8269 49 74 74 +8270 49 74 74 +8271 49 74 74 +8272 49 74 74 +8273 49 74 74 +8274 49 74 74 +8275 49 74 74 +8276 49 74 74 +8277 49 74 74 +8278 49 74 74 +8279 49 74 74 +8280 49 74 74 +8281 49 74 74 +8282 49 74 74 +8283 49 74 74 +8284 49 74 74 +8285 49 74 74 +8286 49 74 74 +8287 49 74 74 +8288 49 74 74 +8289 49 74 74 +8290 49 74 74 +8291 49 74 74 +8292 49 74 74 +8293 49 74 74 +8294 49 74 74 +8295 49 74 74 +8296 49 74 74 +8297 49 74 74 +8298 49 74 74 +8299 49 74 74 +8300 49 74 74 +8301 49 74 74 +8302 49 74 74 +8303 49 74 74 +8304 49 74 74 +8305 49 74 74 +8306 49 74 74 +8307 49 74 74 +8308 49 74 74 +8309 49 74 74 +8310 49 74 74 +8311 49 74 74 +8312 49 74 74 +8313 49 74 74 +8314 49 74 74 +8315 49 74 74 +8316 49 74 74 +8317 49 74 74 +8318 49 74 74 +8319 49 74 74 +8320 49 74 74 +8321 49 74 74 +8322 49 74 74 +8323 49 74 74 +8324 49 74 74 +8325 49 74 74 +8326 49 74 74 +8327 49 74 74 +8328 49 74 74 +8329 49 74 74 +8330 49 74 74 +8331 49 74 74 +8332 49 74 74 +8333 49 74 74 +8334 49 74 74 +8335 49 74 74 +8336 49 74 74 +8337 49 74 74 +8338 49 74 74 +8339 49 74 74 +8340 49 74 74 +8341 49 74 74 +8342 49 74 74 +8343 49 74 74 +8344 49 74 74 +8345 49 74 74 +8346 49 74 74 +8347 49 74 74 +8348 49 74 74 +8349 49 74 74 +8350 49 74 74 +8351 49 74 74 +8352 49 74 74 +8353 49 74 74 +8354 49 74 74 +8355 49 74 74 +8356 49 74 74 +8357 49 74 74 +8358 49 74 74 +8359 49 74 74 +8360 49 74 74 +8361 49 74 74 +8362 49 74 74 +8363 49 74 74 +8364 49 74 74 +8365 49 74 74 +8366 49 74 74 +8367 49 74 74 +8368 49 74 74 +8369 49 74 74 +8370 49 74 74 +8371 49 74 74 +8372 49 74 74 +8373 49 74 74 +8374 49 74 74 +8375 49 74 74 +8376 49 74 74 +8377 49 74 74 +8378 49 74 74 +8379 49 74 74 +8380 49 74 74 +8381 49 74 74 +8382 49 74 74 +8383 49 74 74 +8384 49 74 74 +8385 49 74 74 +8386 49 74 74 +8387 49 74 74 +8388 49 74 74 +8389 49 74 74 +8390 49 74 74 +8391 49 74 74 +8392 49 74 74 +8393 49 74 74 +8394 49 74 74 +8395 49 74 74 +8396 49 74 74 +8397 49 74 74 +8398 49 74 74 +8399 49 74 74 +8400 49 74 74 +8401 49 74 74 +8402 49 74 74 +8403 49 74 74 +8404 49 74 74 +8405 49 74 74 +8406 49 74 74 +8407 49 74 74 +8408 49 74 74 +8409 49 74 74 +8410 49 74 74 +8411 49 74 74 +8412 49 74 74 +8413 49 74 74 +8414 49 74 74 +8415 49 74 74 +8416 49 74 74 +8417 49 74 74 +8418 49 74 74 +8419 49 74 74 +8420 49 74 74 +8421 49 74 74 +8422 49 74 74 +8423 49 74 74 +8424 49 74 74 +8425 49 74 74 +8426 49 74 74 +8427 49 74 74 +8428 49 74 74 +8429 49 74 74 +8430 49 74 74 +8431 49 74 74 +8432 49 74 74 +8433 49 74 74 +8434 49 74 74 +8435 49 74 74 +8436 49 74 74 +8437 49 74 74 +8438 49 74 74 +8439 49 74 74 +8440 49 74 74 +8441 49 74 74 +8442 49 74 74 +8443 49 74 74 +8444 49 74 74 +8445 49 74 74 +8446 49 74 74 +8447 49 74 74 +8448 49 74 74 +8449 49 74 74 +8450 49 74 74 +8451 49 74 74 +8452 49 74 74 +8453 49 74 74 +8454 49 74 74 +8455 49 74 74 +8456 49 74 74 +8457 49 74 74 +8458 49 74 74 +8459 49 74 74 +8460 49 74 74 +8461 49 74 74 +8462 49 74 74 +8463 49 74 74 +8464 49 74 74 +8465 49 74 74 +8466 49 74 74 +8467 49 74 74 +8468 49 74 74 +8469 49 74 74 +8470 49 74 74 +8471 49 74 74 +8472 49 74 74 +8473 49 74 74 +8474 49 74 74 +8475 49 74 74 +8476 49 74 74 +8477 49 74 74 +8478 49 74 74 +8479 49 74 74 +8480 49 74 74 +8481 49 74 74 +8482 49 74 74 +8483 49 74 74 +8484 49 74 74 +8485 49 74 74 +8486 49 74 74 +8487 49 74 74 +8488 49 74 74 +8489 49 74 74 +8490 49 74 74 +8491 49 74 74 +8492 49 74 74 +8493 49 74 74 +8494 49 74 74 +8495 49 74 74 +8496 49 74 74 +8497 49 74 74 +8498 49 74 74 +8499 49 74 74 +8500 49 74 74 +8501 49 74 74 +8502 49 74 74 +8503 49 74 74 +8504 49 74 74 +8505 49 74 74 +8506 49 74 74 +8507 49 74 74 +8508 49 74 74 +8509 49 74 74 +8510 49 74 74 +8511 49 74 74 +8512 49 74 74 +8513 49 74 74 +8514 49 74 74 +8515 49 74 74 +8516 49 74 74 +8517 49 74 74 +8518 49 74 74 +8519 49 74 74 +8520 49 74 74 +8521 49 74 74 +8522 49 74 74 +8523 49 74 74 +8524 49 74 74 +8525 49 74 74 +8526 49 74 74 +8527 49 74 74 +8528 49 74 74 +8529 49 74 74 +8530 49 74 74 +8531 49 74 74 +8532 49 74 74 +8533 49 74 74 +8534 49 74 74 +8535 49 74 74 +8536 49 74 74 +8537 49 74 74 +8538 49 74 74 +8539 49 74 74 +8540 49 74 74 +8541 49 74 74 +8542 49 74 74 +8543 49 74 74 +8544 49 74 74 +8545 49 74 74 +8546 49 74 74 +8547 49 74 74 +8548 49 74 74 +8549 49 74 74 +8550 49 74 74 +8551 49 74 74 +8552 49 74 74 +8553 49 74 74 +8554 49 74 74 +8555 49 74 74 +8556 49 74 74 +8557 49 74 74 +8558 49 74 74 +8559 49 74 74 +8560 49 74 74 +8561 49 74 74 +8562 49 74 74 +8563 49 74 74 +8564 49 74 74 +8565 49 74 74 +8566 49 74 74 +8567 49 74 74 +8568 49 74 74 +8569 49 74 74 +8570 49 74 74 +8571 49 74 74 +8572 49 74 74 +8573 49 74 74 +8574 49 74 74 +8575 49 74 74 +8576 49 74 74 +8577 49 74 74 +8578 49 74 74 +8579 49 74 74 +8580 49 74 74 +8581 49 74 74 +8582 49 74 74 +8583 49 74 74 +8584 49 74 74 +8585 49 74 74 +8586 49 74 74 +8587 49 74 74 +8588 49 74 74 +8589 49 74 74 +8590 49 74 74 +8591 49 74 74 +8592 49 74 74 +8593 49 74 74 +8594 49 74 74 +8595 49 74 74 +8596 49 74 74 +8597 49 74 74 +8598 49 74 74 +8599 49 74 74 +8600 49 74 74 +8601 49 74 74 +8602 49 74 74 +8603 49 74 74 +8604 49 74 74 +8605 49 74 74 +8606 49 74 74 +8607 49 74 74 +8608 49 74 74 +8609 49 74 74 +8610 49 74 74 +8611 49 74 74 +8612 49 74 74 +8613 49 74 74 +8614 49 74 74 +8615 49 74 74 +8616 49 74 74 +8617 49 74 74 +8618 49 74 74 +8619 49 74 74 +8620 49 74 74 +8621 49 74 74 +8622 49 74 74 +8623 49 74 74 +8624 49 74 74 +8625 49 74 74 +8626 49 74 74 +8627 49 74 74 +8628 49 74 74 +8629 49 74 74 +8630 49 74 74 +8631 49 74 74 +8632 49 74 74 +8633 49 74 74 +8634 49 74 74 +8635 49 74 74 +8636 49 74 74 +8637 49 74 74 +8638 49 74 74 +8639 49 74 74 +8640 49 74 74 +8641 49 74 74 +8642 49 74 74 +8643 49 74 74 +8644 49 74 74 +8645 49 74 74 +8646 49 74 74 +8647 49 74 74 +8648 49 74 74 +8649 49 74 74 +8650 49 74 74 +8651 49 74 74 +8652 49 74 74 +8653 49 74 74 +8654 49 74 74 +8655 49 74 74 +8656 49 74 74 +8657 49 74 74 +8658 49 74 74 +8659 49 74 74 +8660 49 74 74 +8661 49 74 74 +8662 49 74 74 +8663 49 74 74 +8664 49 74 74 +8665 49 74 74 +8666 49 74 74 +8667 49 74 74 +8668 49 74 74 +8669 49 74 74 +8670 49 74 74 +8671 49 74 74 +8672 49 74 74 +8673 49 74 74 +8674 49 74 74 +8675 49 74 74 +8676 49 74 74 +8677 49 74 74 +8678 49 74 74 +8679 49 74 74 +8680 49 74 74 +8681 49 74 74 +8682 49 74 74 +8683 49 74 74 +8684 49 74 74 +8685 49 74 74 +8686 49 74 74 +8687 49 74 74 +8688 49 74 74 +8689 49 74 74 +8690 49 74 74 +8691 49 74 74 +8692 49 74 74 +8693 49 74 74 +8694 49 74 74 +8695 49 74 74 +8696 49 74 74 +8697 49 74 74 +8698 49 74 74 +8699 49 74 74 +8700 49 74 74 +8701 49 74 74 +8702 49 74 74 +8703 49 74 74 +8704 49 74 74 +8705 49 74 74 +8706 49 74 74 +8707 49 74 74 +8708 49 74 74 +8709 49 74 74 +8710 49 74 74 +8711 49 74 74 +8712 49 74 74 +8713 49 74 74 +8714 49 74 74 +8715 49 74 74 +8716 49 74 74 +8717 49 74 74 +8718 49 74 74 +8719 49 74 74 +8720 49 74 74 +8721 49 74 74 +8722 49 74 74 +8723 49 74 74 +8724 49 74 74 +8725 49 74 74 +8726 49 74 74 +8727 49 74 74 +8728 49 74 74 +8729 49 74 74 +8730 49 74 74 +8731 49 74 74 +8732 49 74 74 +8733 49 74 74 +8734 49 74 74 +8735 49 74 74 +8736 49 74 74 +8737 49 74 74 +8738 49 74 74 +8739 49 74 74 +8740 49 74 74 +8741 49 74 74 +8742 49 74 74 +8743 49 74 74 +8744 49 74 74 +8745 49 74 74 +8746 49 74 74 +8747 49 74 74 +8748 49 74 74 +8749 49 74 74 +8750 49 74 74 +8751 49 74 74 +8752 49 74 74 +8753 49 74 74 +8754 49 74 74 +8755 49 74 74 +8756 49 74 74 +8757 49 74 74 +8758 49 74 74 +8759 49 74 74 +8760 49 74 74 +8761 49 74 74 +8762 49 74 74 +8763 49 74 74 +8764 49 74 74 +8765 49 74 74 +8766 49 74 74 +8767 49 74 74 +8768 49 74 74 +8769 49 74 74 +8770 49 74 74 +8771 49 74 74 +8772 49 74 74 +8773 49 74 74 +8774 49 74 74 +8775 49 74 74 +8776 49 74 74 +8777 49 74 74 +8778 49 74 74 +8779 49 74 74 +8780 49 74 74 +8781 49 74 74 +8782 49 74 74 +8783 49 74 74 +8784 49 74 74 +8785 49 74 74 +8786 49 74 74 +8787 49 74 74 +8788 49 74 74 +8789 49 74 74 +8790 49 74 74 +8791 49 74 74 +8792 49 74 74 +8793 49 74 74 +8794 49 74 74 +8795 49 74 74 +8796 49 74 74 +8797 49 74 74 +8798 49 74 74 +8799 49 74 74 +8800 49 74 74 +8801 49 74 74 +8802 49 74 74 +8803 49 74 74 +8804 49 74 74 +8805 49 74 74 +8806 49 74 74 +8807 49 74 74 +8808 49 74 74 +8809 49 74 74 +8810 49 74 74 +8811 49 74 74 +8812 49 74 74 +8813 49 74 74 +8814 49 74 74 +8815 49 74 74 +8816 49 74 74 +8817 49 74 74 +8818 49 74 74 +8819 49 74 74 +8820 49 74 74 +8821 49 74 74 +8822 49 74 74 +8823 49 74 74 +8824 49 74 74 +8825 49 74 74 +8826 49 74 74 +8827 49 74 74 +8828 49 74 74 +8829 49 74 74 +8830 49 74 74 +8831 49 74 74 +8832 49 74 74 +8833 49 74 74 +8834 49 74 74 +8835 49 74 74 +8836 49 74 74 +8837 49 74 74 +8838 49 74 74 +8839 49 74 74 +8840 49 74 74 +8841 49 74 74 +8842 49 74 74 +8843 49 74 74 +8844 49 74 74 +8845 49 74 74 +8846 49 74 74 +8847 49 74 74 +8848 49 74 74 +8849 49 74 74 +8850 49 74 74 +8851 49 74 74 +8852 49 74 74 +8853 49 74 74 +8854 49 74 74 +8855 49 74 74 +8856 49 74 74 +8857 49 74 74 +8858 49 74 74 +8859 49 74 74 +8860 49 74 74 +8861 49 74 74 +8862 49 74 74 +8863 49 74 74 +8864 49 74 74 +8865 49 74 74 +8866 49 74 74 +8867 49 74 74 +8868 49 74 74 +8869 49 74 74 +8870 49 74 74 +8871 49 74 74 +8872 49 74 74 +8873 49 74 74 +8874 49 74 74 +8875 49 74 74 +8876 49 74 74 +8877 49 74 74 +8878 49 74 74 +8879 49 74 74 +8880 49 74 74 +8881 49 74 74 +8882 49 74 74 +8883 49 74 74 +8884 49 74 74 +8885 49 74 74 +8886 49 74 74 +8887 49 74 74 +8888 49 74 74 +8889 49 74 74 +8890 49 74 74 +8891 49 74 74 +8892 49 74 74 +8893 49 74 74 +8894 49 74 74 +8895 49 74 74 +8896 49 74 74 +8897 49 74 74 +8898 49 74 74 +8899 49 74 74 +8900 49 74 74 +8901 49 74 74 +8902 49 74 74 +8903 49 74 74 +8904 49 74 74 +8905 49 74 74 +8906 49 74 74 +8907 49 74 74 +8908 49 74 74 +8909 49 74 74 +8910 49 74 74 +8911 49 74 74 +8912 49 74 74 +8913 49 74 74 +8914 49 74 74 +8915 49 74 74 +8916 49 74 74 +8917 49 74 74 +8918 49 74 74 +8919 49 74 74 +8920 49 74 74 +8921 49 74 74 +8922 49 74 74 +8923 49 74 74 +8924 49 74 74 +8925 49 74 74 +8926 49 74 74 +8927 49 74 74 +8928 49 74 74 +8929 49 74 74 +8930 49 74 74 +8931 49 74 74 +8932 49 74 74 +8933 49 74 74 +8934 49 74 74 +8935 49 74 74 +8936 49 74 74 +8937 49 74 74 +8938 49 74 74 +8939 49 74 74 +8940 49 74 74 +8941 49 74 74 +8942 49 74 74 +8943 49 74 74 +8944 49 74 74 +8945 49 74 74 +8946 49 74 74 +8947 49 74 74 +8948 49 74 74 +8949 49 74 74 +8950 49 74 74 +8951 49 74 74 +8952 49 74 74 +8953 49 74 74 +8954 49 74 74 +8955 49 74 74 +8956 49 74 74 +8957 49 74 74 +8958 49 74 74 +8959 49 74 74 +8960 49 74 74 +8961 49 74 74 +8962 49 74 74 +8963 49 74 74 +8964 49 74 74 +8965 49 74 74 +8966 49 74 74 +8967 49 74 74 +8968 49 74 74 +8969 49 74 74 +8970 49 74 74 +8971 49 74 74 +8972 49 74 74 +8973 49 74 74 +8974 49 74 74 +8975 49 74 74 +8976 49 74 74 +8977 49 74 74 +8978 49 74 74 +8979 49 74 74 +8980 49 74 74 +8981 49 74 74 +8982 49 74 74 +8983 49 74 74 +8984 49 74 74 +8985 49 74 74 +8986 49 74 74 +8987 49 74 74 +8988 49 74 74 +8989 49 74 74 +8990 49 74 74 +8991 49 74 74 +8992 49 74 74 +8993 49 74 74 +8994 49 74 74 +8995 49 74 74 +8996 49 74 74 +8997 49 74 74 +8998 49 74 74 +8999 49 74 74 +9000 49 74 74 +9001 49 74 74 +9002 49 74 74 +9003 49 74 74 +9004 49 74 74 +9005 49 74 74 +9006 49 74 74 +9007 49 74 74 +9008 49 74 74 +9009 49 74 74 +9010 49 74 74 +9011 49 74 74 +9012 49 74 74 +9013 49 74 74 +9014 49 74 74 +9015 49 74 74 +9016 49 74 74 +9017 49 74 74 +9018 49 74 74 +9019 49 74 74 +9020 49 74 74 +9021 49 74 74 +9022 49 74 74 +9023 49 74 74 +9024 49 74 74 +9025 49 74 74 +9026 49 74 74 +9027 49 74 74 +9028 49 74 74 +9029 49 74 74 +9030 49 74 74 +9031 49 74 74 +9032 49 74 74 +9033 49 74 74 +9034 49 74 74 +9035 49 74 74 +9036 49 74 74 +9037 49 74 74 +9038 49 74 74 +9039 49 74 74 +9040 49 74 74 +9041 49 74 74 +9042 49 74 74 +9043 49 74 74 +9044 49 74 74 +9045 49 74 74 +9046 49 74 74 +9047 49 74 74 +9048 49 74 74 +9049 49 74 74 +9050 49 74 74 +9051 49 74 74 +9052 49 74 74 +9053 49 74 74 +9054 49 74 74 +9055 49 74 74 +9056 49 74 74 +9057 49 74 74 +9058 49 74 74 +9059 49 74 74 +9060 49 74 74 +9061 49 74 74 +9062 49 74 74 +9063 49 74 74 +9064 49 74 74 +9065 49 74 74 +9066 49 74 74 +9067 49 74 74 +9068 49 74 74 +9069 49 74 74 +9070 49 74 74 +9071 49 74 74 +9072 49 74 74 +9073 49 74 74 +9074 49 74 74 +9075 49 74 74 +9076 49 74 74 +9077 49 74 74 +9078 49 74 74 +9079 49 74 74 +9080 49 74 74 +9081 49 74 74 +9082 49 74 74 +9083 49 74 74 +9084 49 74 74 +9085 49 74 74 +9086 49 74 74 +9087 49 74 74 +9088 49 74 74 +9089 49 74 74 +9090 49 74 74 +9091 49 74 74 +9092 49 74 74 +9093 49 74 74 +9094 49 74 74 +9095 49 74 74 +9096 49 74 74 +9097 49 74 74 +9098 49 74 74 +9099 49 74 74 +9100 49 74 74 +9101 49 74 74 +9102 49 74 74 +9103 49 74 74 +9104 49 74 74 +9105 49 74 74 +9106 49 74 74 +9107 49 74 74 +9108 49 74 74 +9109 49 74 74 +9110 49 74 74 +9111 49 74 74 +9112 49 74 74 +9113 49 74 74 +9114 49 74 74 +9115 49 74 74 +9116 49 74 74 +9117 49 74 74 +9118 49 74 74 +9119 49 74 74 +9120 49 74 74 +9121 49 74 74 +9122 49 74 74 +9123 49 74 74 +9124 49 74 74 +9125 49 74 74 +9126 49 74 74 +9127 49 74 74 +9128 49 74 74 +9129 49 74 74 +9130 49 74 74 +9131 49 74 74 +9132 49 74 74 +9133 49 74 74 +9134 49 74 74 +9135 49 74 74 +9136 49 74 74 +9137 49 74 74 +9138 49 74 74 +9139 49 74 74 +9140 49 74 74 +9141 49 74 74 +9142 49 74 74 +9143 49 74 74 +9144 49 74 74 +9145 49 74 74 +9146 49 74 74 +9147 49 74 74 +9148 49 74 74 +9149 49 74 74 +9150 49 74 74 +9151 49 74 74 +9152 49 74 74 +9153 49 74 74 +9154 49 74 74 +9155 49 74 74 +9156 49 74 74 +9157 49 74 74 +9158 49 74 74 +9159 49 74 74 +9160 49 74 74 +9161 49 74 74 +9162 49 74 74 +9163 49 74 74 +9164 49 74 74 +9165 49 74 74 +9166 49 74 74 +9167 49 74 74 +9168 49 74 74 +9169 49 74 74 +9170 49 74 74 +9171 49 74 74 +9172 49 74 74 +9173 49 74 74 +9174 49 74 74 +9175 49 74 74 +9176 49 74 74 +9177 49 74 74 +9178 49 74 74 +9179 49 74 74 +9180 49 74 74 +9181 49 74 74 +9182 49 74 74 +9183 49 74 74 +9184 49 74 74 +9185 49 74 74 +9186 49 74 74 +9187 49 74 74 +9188 49 74 74 +9189 49 74 74 +9190 49 74 74 +9191 49 74 74 +9192 49 74 74 +9193 49 74 74 +9194 49 74 74 +9195 49 74 74 +9196 49 74 74 +9197 49 74 74 +9198 49 74 74 +9199 49 74 74 +9200 49 74 74 +9201 49 74 74 +9202 49 74 74 +9203 49 74 74 +9204 49 74 74 +9205 49 74 74 +9206 49 74 74 +9207 49 74 74 +9208 49 74 74 +9209 49 74 74 +9210 49 74 74 +9211 49 74 74 +9212 49 74 74 +9213 49 74 74 +9214 49 74 74 +9215 49 74 74 +9216 49 74 74 +9217 49 74 74 +9218 49 74 74 +9219 49 74 74 +9220 49 74 74 +9221 49 74 74 +9222 49 74 74 +9223 49 74 74 +9224 49 74 74 +9225 49 74 74 +9226 49 74 74 +9227 49 74 74 +9228 49 74 74 +9229 49 74 74 +9230 49 74 74 +9231 49 74 74 +9232 49 74 74 +9233 49 74 74 +9234 49 74 74 +9235 49 74 74 +9236 49 74 74 +9237 49 74 74 +9238 49 74 74 +9239 49 74 74 +9240 49 74 74 +9241 49 74 74 +9242 49 74 74 +9243 49 74 74 +9244 49 74 74 +9245 49 74 74 +9246 49 74 74 +9247 49 74 74 +9248 49 74 74 +9249 49 74 74 +9250 49 74 74 +9251 49 74 74 +9252 49 74 74 +9253 49 74 74 +9254 49 74 74 +9255 49 74 74 +9256 49 74 74 +9257 49 74 74 +9258 49 74 74 +9259 49 74 74 +9260 49 74 74 +9261 49 74 74 +9262 49 74 74 +9263 49 74 74 +9264 49 74 74 +9265 49 74 74 +9266 49 74 74 +9267 49 74 74 +9268 49 74 74 +9269 49 74 74 +9270 49 74 74 +9271 49 74 74 +9272 49 74 74 +9273 49 74 74 +9274 49 74 74 +9275 49 74 74 +9276 49 74 74 +9277 49 74 74 +9278 49 74 74 +9279 49 74 74 +9280 49 74 74 +9281 49 74 74 +9282 49 74 74 +9283 49 74 74 +9284 49 74 74 +9285 49 74 74 +9286 49 74 74 +9287 49 74 74 +9288 49 74 74 +9289 49 74 74 +9290 49 74 74 +9291 49 74 74 +9292 49 74 74 +9293 49 74 74 +9294 49 74 74 +9295 49 74 74 +9296 49 74 74 +9297 49 74 74 +9298 49 74 74 +9299 49 74 74 +9300 49 74 74 +9301 49 74 74 +9302 49 74 74 +9303 49 74 74 +9304 49 74 74 +9305 49 74 74 +9306 49 74 74 +9307 49 74 74 +9308 49 74 74 +9309 49 74 74 +9310 49 74 74 +9311 49 74 74 +9312 49 74 74 +9313 49 74 74 +9314 49 74 74 +9315 49 74 74 +9316 49 74 74 +9317 49 74 74 +9318 49 74 74 +9319 49 74 74 +9320 49 74 74 +9321 49 74 74 +9322 49 74 74 +9323 49 74 74 +9324 49 74 74 +9325 49 74 74 +9326 49 74 74 +9327 49 74 74 +9328 49 74 74 +9329 49 74 74 +9330 49 74 74 +9331 49 74 74 +9332 49 74 74 +9333 49 74 74 +9334 49 74 74 +9335 49 74 74 +9336 49 74 74 +9337 49 74 74 +9338 49 74 74 +9339 49 74 74 +9340 49 74 74 +9341 49 74 74 +9342 49 74 74 +9343 49 74 74 +9344 49 74 74 +9345 49 74 74 +9346 49 74 74 +9347 49 74 74 +9348 49 74 74 +9349 49 74 74 +9350 49 74 74 +9351 49 74 74 +9352 49 74 74 +9353 49 74 74 +9354 49 74 74 +9355 49 74 74 +9356 49 74 74 +9357 49 74 74 +9358 49 74 74 +9359 49 74 74 +9360 49 74 74 +9361 49 74 74 +9362 49 74 74 +9363 49 74 74 +9364 49 74 74 +9365 49 74 74 +9366 49 74 74 +9367 49 74 74 +9368 49 74 74 +9369 49 74 74 +9370 49 74 74 +9371 49 74 74 +9372 49 74 74 +9373 49 74 74 +9374 49 74 74 +9375 49 74 74 +9376 49 74 74 +9377 49 74 74 +9378 49 74 74 +9379 49 74 74 +9380 49 74 74 +9381 49 74 74 +9382 49 74 74 +9383 49 74 74 +9384 49 74 74 +9385 49 74 74 +9386 49 74 74 +9387 49 74 74 +9388 49 74 74 +9389 49 74 74 +9390 49 74 74 +9391 49 74 74 +9392 49 74 74 +9393 49 74 74 +9394 49 74 74 +9395 49 74 74 +9396 49 74 74 +9397 49 74 74 +9398 49 74 74 +9399 49 74 74 +9400 49 74 74 +9401 49 74 74 +9402 49 74 74 +9403 49 74 74 +9404 49 74 74 +9405 49 74 74 +9406 49 74 74 +9407 49 74 74 +9408 49 74 74 +9409 49 74 74 +9410 49 74 74 +9411 49 74 74 +9412 49 74 74 +9413 49 74 74 +9414 49 74 74 +9415 49 74 74 +9416 49 74 74 +9417 49 74 74 +9418 49 74 74 +9419 49 74 74 +9420 49 74 74 +9421 49 74 74 +9422 49 74 74 +9423 49 74 74 +9424 49 74 74 +9425 49 74 74 +9426 49 74 74 +9427 49 74 74 +9428 49 74 74 +9429 49 74 74 +9430 49 74 74 +9431 49 74 74 +9432 49 74 74 +9433 49 74 74 +9434 49 74 74 +9435 49 74 74 +9436 49 74 74 +9437 49 74 74 +9438 49 74 74 +9439 49 74 74 +9440 49 74 74 +9441 49 74 74 +9442 49 74 74 +9443 49 74 74 +9444 49 74 74 +9445 49 74 74 +9446 49 74 74 +9447 49 74 74 +9448 49 74 74 +9449 49 74 74 +9450 49 74 74 +9451 49 74 74 +9452 49 74 74 +9453 49 74 74 +9454 49 74 74 +9455 49 74 74 +9456 49 74 74 +9457 49 74 74 +9458 49 74 74 +9459 49 74 74 +9460 49 74 74 +9461 49 74 74 +9462 49 74 74 +9463 49 74 74 +9464 49 74 74 +9465 49 74 74 +9466 49 74 74 +9467 49 74 74 +9468 49 74 74 +9469 49 74 74 +9470 49 74 74 +9471 49 74 74 +9472 49 74 74 +9473 49 74 74 +9474 49 74 74 +9475 49 74 74 +9476 49 74 74 +9477 49 74 74 +9478 49 74 74 +9479 49 74 74 +9480 49 74 74 +9481 49 74 74 +9482 49 74 74 +9483 49 74 74 +9484 49 74 74 +9485 49 74 74 +9486 49 74 74 +9487 49 74 74 +9488 49 74 74 +9489 49 74 74 +9490 49 74 74 +9491 49 74 74 +9492 49 74 74 +9493 49 74 74 +9494 49 74 74 +9495 49 74 74 +9496 49 74 74 +9497 49 74 74 +9498 49 74 74 +9499 49 74 74 +9500 49 74 74 +9501 49 74 74 +9502 49 74 74 +9503 49 74 74 +9504 49 74 74 +9505 49 74 74 +9506 49 74 74 +9507 49 74 74 +9508 49 74 74 +9509 49 74 74 +9510 49 74 74 +9511 49 74 74 +9512 49 74 74 +9513 49 74 74 +9514 49 74 74 +9515 49 74 74 +9516 49 74 74 +9517 49 74 74 +9518 49 74 74 +9519 49 74 74 +9520 49 74 74 +9521 49 74 74 +9522 49 74 74 +9523 49 74 74 +9524 49 74 74 +9525 49 74 74 +9526 49 74 74 +9527 49 74 74 +9528 49 74 74 +9529 49 74 74 +9530 49 74 74 +9531 49 74 74 +9532 49 74 74 +9533 49 74 74 +9534 49 74 74 +9535 49 74 74 +9536 49 74 74 +9537 49 74 74 +9538 49 74 74 +9539 49 74 74 +9540 49 74 74 +9541 49 74 74 +9542 49 74 74 +9543 49 74 74 +9544 49 74 74 +9545 49 74 74 +9546 49 74 74 +9547 49 74 74 +9548 49 74 74 +9549 49 74 74 +9550 49 74 74 +9551 49 74 74 +9552 49 74 74 +9553 49 74 74 +9554 49 74 74 +9555 49 74 74 +9556 49 74 74 +9557 49 74 74 +9558 49 74 74 +9559 49 74 74 +9560 49 74 74 +9561 49 74 74 +9562 49 74 74 +9563 49 74 74 +9564 49 74 74 +9565 49 74 74 +9566 49 74 74 +9567 49 74 74 +9568 49 74 74 +9569 49 74 74 +9570 49 74 74 +9571 49 74 74 +9572 49 74 74 +9573 49 74 74 +9574 49 74 74 +9575 49 74 74 +9576 49 74 74 +9577 49 74 74 +9578 49 74 74 +9579 49 74 74 +9580 49 74 74 +9581 49 74 74 +9582 49 74 74 +9583 49 74 74 +9584 49 74 74 +9585 49 74 74 +9586 49 74 74 +9587 49 74 74 +9588 49 74 74 +9589 49 74 74 +9590 49 74 74 +9591 49 74 74 +9592 49 74 74 +9593 49 74 74 +9594 49 74 74 +9595 49 74 74 +9596 49 74 74 +9597 49 74 74 +9598 49 74 74 +9599 49 74 74 +9600 49 74 74 +9601 49 74 74 +9602 49 74 74 +9603 49 74 74 +9604 49 74 74 +9605 49 74 74 +9606 49 74 74 +9607 49 74 74 +9608 49 74 74 +9609 49 74 74 +9610 49 74 74 +9611 49 74 74 +9612 49 74 74 +9613 49 74 74 +9614 49 74 74 +9615 49 74 74 +9616 49 74 74 +9617 49 74 74 +9618 49 74 74 +9619 49 74 74 +9620 49 74 74 +9621 49 74 74 +9622 49 74 74 +9623 49 74 74 +9624 49 74 74 +9625 49 74 74 +9626 49 74 74 +9627 49 74 74 +9628 49 74 74 +9629 49 74 74 +9630 49 74 74 +9631 49 74 74 +9632 49 74 74 +9633 49 74 74 +9634 49 74 74 +9635 49 74 74 +9636 49 74 74 +9637 49 74 74 +9638 49 74 74 +9639 49 74 74 +9640 49 74 74 +9641 49 74 74 +9642 49 74 74 +9643 49 74 74 +9644 49 74 74 +9645 49 74 74 +9646 49 74 74 +9647 49 74 74 +9648 49 74 74 +9649 49 74 74 +9650 49 74 74 +9651 49 74 74 +9652 49 74 74 +9653 49 74 74 +9654 49 74 74 +9655 49 74 74 +9656 49 74 74 +9657 49 74 74 +9658 49 74 74 +9659 49 74 74 +9660 49 74 74 +9661 49 74 74 +9662 49 74 74 +9663 49 74 74 +9664 49 74 74 +9665 49 74 74 +9666 49 74 74 +9667 49 74 74 +9668 49 74 74 +9669 49 74 74 +9670 49 74 74 +9671 49 74 74 +9672 49 74 74 +9673 49 74 74 +9674 49 74 74 +9675 49 74 74 +9676 49 74 74 +9677 49 74 74 +9678 49 74 74 +9679 49 74 74 +9680 49 74 74 +9681 49 74 74 +9682 49 74 74 +9683 49 74 74 +9684 49 74 74 +9685 49 74 74 +9686 49 74 74 +9687 49 74 74 +9688 49 74 74 +9689 49 74 74 +9690 49 74 74 +9691 49 74 74 +9692 49 74 74 +9693 49 74 74 +9694 49 74 74 +9695 49 74 74 +9696 49 74 74 +9697 49 74 74 +9698 49 74 74 +9699 49 74 74 +9700 49 74 74 +9701 49 74 74 +9702 49 74 74 +9703 49 74 74 +9704 49 74 74 +9705 49 74 74 +9706 49 74 74 +9707 49 74 74 +9708 49 74 74 +9709 49 74 74 +9710 49 74 74 +9711 49 74 74 +9712 49 74 74 +9713 49 74 74 +9714 49 74 74 +9715 49 74 74 +9716 49 74 74 +9717 49 74 74 +9718 49 74 74 +9719 49 74 74 +9720 49 74 74 +9721 49 74 74 +9722 49 74 74 +9723 49 74 74 +9724 49 74 74 +9725 49 74 74 +9726 49 74 74 +9727 49 74 74 +9728 49 74 74 +9729 49 74 74 +9730 49 74 74 +9731 49 74 74 +9732 49 74 74 +9733 49 74 74 +9734 49 74 74 +9735 49 74 74 +9736 49 74 74 +9737 49 74 74 +9738 49 74 74 +9739 49 74 74 +9740 49 74 74 +9741 49 74 74 +9742 49 74 74 +9743 49 74 74 Angles @@ -25775,6 +28610,7 @@ Bond Coeffs 46 1.081 370.5 -944.775 1405.3528125 47 1.509 345.0 -879.75 1308.628125 48 0.9572 556.85 -1419.9675 2112.20165625 +49 -7.6 1.5537 0.0 0.0 Angle Coeffs @@ -26231,9743 +29067,3 @@ BondAngle Coeffs 109 11.5 11.5 1.112 1.509 110 18.7 18.7 1.509 1.2553 111 0.0 0.0 0.0 0.0 - -Tinker Types - -1 234 -2 8 -3 9 -4 11 -5 235 -6 235 -7 235 -8 12 -9 178 -10 180 -11 182 -12 183 -13 179 -14 179 -15 181 -16 181 -17 184 -18 184 -19 184 -20 7 -21 8 -22 9 -23 11 -24 10 -25 12 -26 170 -27 172 -28 174 -29 175 -30 176 -31 171 -32 171 -33 173 -34 173 -35 177 -36 177 -37 7 -38 8 -39 9 -40 11 -41 10 -42 12 -43 25 -44 29 -45 27 -46 31 -47 26 -48 30 -49 30 -50 28 -51 28 -52 28 -53 32 -54 32 -55 32 -56 7 -57 8 -58 9 -59 11 -60 10 -61 12 -62 64 -63 66 -64 67 -65 67 -66 69 -67 69 -68 71 -69 65 -70 65 -71 68 -72 68 -73 70 -74 70 -75 72 -76 7 -77 8 -78 9 -79 11 -80 10 -81 12 -82 15 -83 17 -84 17 -85 16 -86 18 -87 18 -88 18 -89 18 -90 18 -91 18 -92 7 -93 8 -94 9 -95 11 -96 10 -97 12 -98 185 -99 187 -100 189 -101 191 -102 193 -103 186 -104 186 -105 188 -106 188 -107 190 -108 190 -109 192 -110 192 -111 194 -112 194 -113 194 -114 7 -115 33 -116 9 -117 11 -118 10 -119 12 -120 38 -121 42 -122 40 -123 39 -124 43 -125 41 -126 41 -127 41 -128 7 -129 8 -130 9 -131 11 -132 10 -133 12 -134 19 -135 21 -136 23 -137 23 -138 20 -139 20 -140 22 -141 24 -142 24 -143 24 -144 24 -145 24 -146 24 -147 7 -148 33 -149 9 -150 11 -151 10 -152 12 -153 38 -154 42 -155 40 -156 39 -157 43 -158 41 -159 41 -160 41 -161 1 -162 2 -163 3 -164 5 -165 4 -166 6 -167 6 -168 7 -169 8 -170 9 -171 11 -172 10 -173 12 -174 185 -175 187 -176 189 -177 191 -178 193 -179 186 -180 186 -181 188 -182 188 -183 190 -184 190 -185 192 -186 192 -187 194 -188 194 -189 194 -190 7 -191 33 -192 9 -193 11 -194 10 -195 12 -196 38 -197 42 -198 40 -199 39 -200 43 -201 41 -202 41 -203 41 -204 7 -205 8 -206 9 -207 11 -208 10 -209 12 -210 25 -211 29 -212 27 -213 31 -214 26 -215 30 -216 30 -217 28 -218 28 -219 28 -220 32 -221 32 -222 32 -223 7 -224 33 -225 9 -226 11 -227 10 -228 12 -229 38 -230 42 -231 40 -232 39 -233 43 -234 41 -235 41 -236 41 -237 7 -238 8 -239 9 -240 11 -241 10 -242 12 -243 19 -244 21 -245 23 -246 23 -247 20 -248 20 -249 22 -250 24 -251 24 -252 24 -253 24 -254 24 -255 24 -256 7 -257 8 -258 9 -259 11 -260 10 -261 12 -262 156 -263 158 -264 160 -265 161 -266 161 -267 157 -268 157 -269 159 -270 159 -271 7 -272 8 -273 9 -274 11 -275 10 -276 12 -277 15 -278 17 -279 17 -280 16 -281 18 -282 18 -283 18 -284 18 -285 18 -286 18 -287 7 -288 8 -289 9 -290 11 -291 10 -292 12 -293 156 -294 158 -295 160 -296 161 -297 161 -298 157 -299 157 -300 159 -301 159 -302 53 -303 54 -304 55 -305 56 -306 57 -307 58 -308 60 -309 62 -310 59 -311 59 -312 61 -313 61 -314 63 -315 63 -316 7 -317 33 -318 9 -319 11 -320 10 -321 12 -322 34 -323 36 -324 35 -325 35 -326 37 -327 7 -328 8 -329 9 -330 11 -331 10 -332 12 -333 140 -334 142 -335 143 -336 143 -337 141 -338 141 -339 7 -340 33 -341 9 -342 11 -343 10 -344 12 -345 38 -346 42 -347 40 -348 39 -349 43 -350 41 -351 41 -352 41 -353 7 -354 8 -355 9 -356 11 -357 10 -358 12 -359 25 -360 29 -361 27 -362 31 -363 26 -364 30 -365 30 -366 28 -367 28 -368 28 -369 32 -370 32 -371 32 -372 7 -373 8 -374 9 -375 11 -376 10 -377 12 -378 156 -379 158 -380 160 -381 161 -382 161 -383 157 -384 157 -385 159 -386 159 -387 7 -388 8 -389 9 -390 11 -391 10 -392 12 -393 150 -394 152 -395 153 -396 154 -397 151 -398 151 -399 155 -400 155 -401 7 -402 8 -403 9 -404 11 -405 10 -406 12 -407 15 -408 17 -409 17 -410 16 -411 18 -412 18 -413 18 -414 18 -415 18 -416 18 -417 7 -418 8 -419 9 -420 11 -421 10 -422 12 -423 185 -424 187 -425 189 -426 191 -427 193 -428 186 -429 186 -430 188 -431 188 -432 190 -433 190 -434 192 -435 192 -436 194 -437 194 -438 194 -439 7 -440 8 -441 9 -442 11 -443 10 -444 12 -445 13 -446 14 -447 14 -448 14 -449 7 -450 8 -451 9 -452 11 -453 10 -454 12 -455 185 -456 187 -457 189 -458 191 -459 193 -460 186 -461 186 -462 188 -463 188 -464 190 -465 190 -466 192 -467 192 -468 194 -469 194 -470 194 -471 7 -472 8 -473 9 -474 11 -475 10 -476 12 -477 25 -478 29 -479 27 -480 31 -481 26 -482 30 -483 30 -484 28 -485 28 -486 28 -487 32 -488 32 -489 32 -490 7 -491 8 -492 9 -493 11 -494 10 -495 12 -496 170 -497 172 -498 174 -499 175 -500 176 -501 171 -502 171 -503 173 -504 173 -505 177 -506 177 -507 7 -508 8 -509 9 -510 11 -511 10 -512 12 -513 140 -514 142 -515 143 -516 143 -517 141 -518 141 -519 7 -520 8 -521 9 -522 11 -523 10 -524 12 -525 185 -526 187 -527 189 -528 191 -529 193 -530 186 -531 186 -532 188 -533 188 -534 190 -535 190 -536 192 -537 192 -538 194 -539 194 -540 194 -541 7 -542 8 -543 9 -544 11 -545 10 -546 12 -547 156 -548 158 -549 160 -550 161 -551 161 -552 157 -553 157 -554 159 -555 159 -556 1 -557 2 -558 3 -559 5 -560 4 -561 6 -562 6 -563 7 -564 8 -565 9 -566 11 -567 10 -568 12 -569 25 -570 29 -571 27 -572 31 -573 26 -574 30 -575 30 -576 28 -577 28 -578 28 -579 32 -580 32 -581 32 -582 53 -583 54 -584 55 -585 56 -586 57 -587 58 -588 60 -589 62 -590 59 -591 59 -592 61 -593 61 -594 63 -595 63 -596 53 -597 54 -598 55 -599 56 -600 57 -601 58 -602 60 -603 62 -604 59 -605 59 -606 61 -607 61 -608 63 -609 63 -610 7 -611 8 -612 9 -613 11 -614 10 -615 12 -616 140 -617 142 -618 143 -619 143 -620 141 -621 141 -622 7 -623 8 -624 9 -625 11 -626 10 -627 12 -628 170 -629 172 -630 174 -631 175 -632 176 -633 171 -634 171 -635 173 -636 173 -637 177 -638 177 -639 7 -640 8 -641 9 -642 11 -643 10 -644 12 -645 170 -646 172 -647 174 -648 175 -649 176 -650 171 -651 171 -652 173 -653 173 -654 177 -655 177 -656 7 -657 8 -658 9 -659 11 -660 10 -661 12 -662 205 -663 207 -664 209 -665 211 -666 213 -667 214 -668 214 -669 206 -670 206 -671 208 -672 208 -673 210 -674 210 -675 212 -676 215 -677 215 -678 215 -679 215 -680 7 -681 8 -682 9 -683 11 -684 10 -685 12 -686 19 -687 21 -688 23 -689 23 -690 20 -691 20 -692 22 -693 24 -694 24 -695 24 -696 24 -697 24 -698 24 -699 7 -700 8 -701 9 -702 11 -703 10 -704 12 -705 25 -706 29 -707 27 -708 31 -709 26 -710 30 -711 30 -712 28 -713 28 -714 28 -715 32 -716 32 -717 32 -718 7 -719 8 -720 9 -721 11 -722 10 -723 12 -724 64 -725 66 -726 67 -727 67 -728 69 -729 69 -730 71 -731 65 -732 65 -733 68 -734 68 -735 70 -736 70 -737 72 -738 7 -739 8 -740 9 -741 11 -742 10 -743 12 -744 13 -745 14 -746 14 -747 14 -748 1 -749 2 -750 3 -751 5 -752 4 -753 6 -754 6 -755 7 -756 8 -757 9 -758 11 -759 10 -760 12 -761 185 -762 187 -763 189 -764 191 -765 193 -766 186 -767 186 -768 188 -769 188 -770 190 -771 190 -772 192 -773 192 -774 194 -775 194 -776 194 -777 7 -778 8 -779 9 -780 11 -781 10 -782 12 -783 170 -784 172 -785 174 -786 175 -787 176 -788 171 -789 171 -790 173 -791 173 -792 177 -793 177 -794 7 -795 8 -796 9 -797 11 -798 10 -799 12 -800 19 -801 21 -802 23 -803 23 -804 20 -805 20 -806 22 -807 24 -808 24 -809 24 -810 24 -811 24 -812 24 -813 7 -814 8 -815 9 -816 11 -817 10 -818 12 -819 156 -820 158 -821 160 -822 161 -823 161 -824 157 -825 157 -826 159 -827 159 -828 7 -829 8 -830 9 -831 11 -832 10 -833 12 -834 140 -835 142 -836 143 -837 143 -838 141 -839 141 -840 1 -841 2 -842 3 -843 5 -844 4 -845 6 -846 6 -847 7 -848 8 -849 9 -850 11 -851 10 -852 12 -853 205 -854 207 -855 209 -856 211 -857 213 -858 214 -859 214 -860 206 -861 206 -862 208 -863 208 -864 210 -865 210 -866 212 -867 215 -868 215 -869 215 -870 215 -871 7 -872 33 -873 9 -874 11 -875 10 -876 12 -877 38 -878 42 -879 40 -880 39 -881 43 -882 41 -883 41 -884 41 -885 7 -886 8 -887 9 -888 11 -889 10 -890 12 -891 19 -892 21 -893 23 -894 23 -895 20 -896 20 -897 22 -898 24 -899 24 -900 24 -901 24 -902 24 -903 24 -904 7 -905 33 -906 9 -907 11 -908 10 -909 12 -910 34 -911 36 -912 35 -913 35 -914 37 -915 7 -916 8 -917 9 -918 11 -919 10 -920 12 -921 140 -922 142 -923 143 -924 143 -925 141 -926 141 -927 7 -928 8 -929 9 -930 11 -931 10 -932 12 -933 73 -934 75 -935 76 -936 76 -937 78 -938 78 -939 80 -940 81 -941 74 -942 74 -943 77 -944 77 -945 79 -946 79 -947 82 -948 7 -949 8 -950 9 -951 11 -952 10 -953 12 -954 150 -955 152 -956 153 -957 154 -958 151 -959 151 -960 155 -961 155 -962 7 -963 8 -964 9 -965 11 -966 10 -967 12 -968 25 -969 29 -970 27 -971 31 -972 26 -973 30 -974 30 -975 28 -976 28 -977 28 -978 32 -979 32 -980 32 -981 7 -982 8 -983 9 -984 11 -985 10 -986 12 -987 170 -988 172 -989 174 -990 175 -991 176 -992 171 -993 171 -994 173 -995 173 -996 177 -997 177 -998 7 -999 8 -1000 9 -1001 11 -1002 10 -1003 12 -1004 185 -1005 187 -1006 189 -1007 191 -1008 193 -1009 186 -1010 186 -1011 188 -1012 188 -1013 190 -1014 190 -1015 192 -1016 192 -1017 194 -1018 194 -1019 194 -1020 7 -1021 8 -1022 9 -1023 11 -1024 10 -1025 12 -1026 156 -1027 158 -1028 160 -1029 161 -1030 161 -1031 157 -1032 157 -1033 159 -1034 159 -1035 7 -1036 33 -1037 9 -1038 11 -1039 10 -1040 12 -1041 34 -1042 36 -1043 35 -1044 35 -1045 37 -1046 7 -1047 33 -1048 9 -1049 11 -1050 10 -1051 12 -1052 38 -1053 42 -1054 40 -1055 39 -1056 43 -1057 41 -1058 41 -1059 41 -1060 7 -1061 8 -1062 9 -1063 11 -1064 10 -1065 12 -1066 19 -1067 21 -1068 23 -1069 23 -1070 20 -1071 20 -1072 22 -1073 24 -1074 24 -1075 24 -1076 24 -1077 24 -1078 24 -1079 7 -1080 8 -1081 9 -1082 11 -1083 10 -1084 12 -1085 109 -1086 111 -1087 112 -1088 114 -1089 116 -1090 118 -1091 110 -1092 110 -1093 113 -1094 115 -1095 117 -1096 119 -1097 7 -1098 8 -1099 9 -1100 11 -1101 10 -1102 12 -1103 19 -1104 21 -1105 23 -1106 23 -1107 20 -1108 20 -1109 22 -1110 24 -1111 24 -1112 24 -1113 24 -1114 24 -1115 24 -1116 7 -1117 8 -1118 9 -1119 11 -1120 10 -1121 12 -1122 15 -1123 17 -1124 17 -1125 16 -1126 18 -1127 18 -1128 18 -1129 18 -1130 18 -1131 18 -1132 7 -1133 8 -1134 9 -1135 11 -1136 10 -1137 12 -1138 19 -1139 21 -1140 23 -1141 23 -1142 20 -1143 20 -1144 22 -1145 24 -1146 24 -1147 24 -1148 24 -1149 24 -1150 24 -1151 7 -1152 8 -1153 9 -1154 11 -1155 10 -1156 12 -1157 205 -1158 207 -1159 209 -1160 211 -1161 213 -1162 214 -1163 214 -1164 206 -1165 206 -1166 208 -1167 208 -1168 210 -1169 210 -1170 212 -1171 215 -1172 215 -1173 215 -1174 215 -1175 7 -1176 8 -1177 9 -1178 11 -1179 10 -1180 12 -1181 19 -1182 21 -1183 23 -1184 23 -1185 20 -1186 20 -1187 22 -1188 24 -1189 24 -1190 24 -1191 24 -1192 24 -1193 24 -1194 7 -1195 8 -1196 9 -1197 11 -1198 10 -1199 12 -1200 205 -1201 207 -1202 209 -1203 211 -1204 213 -1205 214 -1206 214 -1207 206 -1208 206 -1209 208 -1210 208 -1211 210 -1212 210 -1213 212 -1214 215 -1215 215 -1216 215 -1217 215 -1218 1 -1219 2 -1220 3 -1221 5 -1222 4 -1223 6 -1224 6 -1225 1 -1226 2 -1227 238 -1228 239 -1229 4 -1230 6 -1231 6 -1232 239 -1233 402 -1234 403 -1235 403 -1236 402 -1237 403 -1238 403 -1239 402 -1240 403 -1241 403 -1242 402 -1243 403 -1244 403 -1245 402 -1246 403 -1247 403 -1248 402 -1249 403 -1250 403 -1251 402 -1252 403 -1253 403 -1254 402 -1255 403 -1256 403 -1257 402 -1258 403 -1259 403 -1260 402 -1261 403 -1262 403 -1263 402 -1264 403 -1265 403 -1266 402 -1267 403 -1268 403 -1269 402 -1270 403 -1271 403 -1272 402 -1273 403 -1274 403 -1275 402 -1276 403 -1277 403 -1278 402 -1279 403 -1280 403 -1281 402 -1282 403 -1283 403 -1284 402 -1285 403 -1286 403 -1287 402 -1288 403 -1289 403 -1290 402 -1291 403 -1292 403 -1293 402 -1294 403 -1295 403 -1296 402 -1297 403 -1298 403 -1299 402 -1300 403 -1301 403 -1302 402 -1303 403 -1304 403 -1305 402 -1306 403 -1307 403 -1308 402 -1309 403 -1310 403 -1311 402 -1312 403 -1313 403 -1314 402 -1315 403 -1316 403 -1317 402 -1318 403 -1319 403 -1320 402 -1321 403 -1322 403 -1323 402 -1324 403 -1325 403 -1326 402 -1327 403 -1328 403 -1329 402 -1330 403 -1331 403 -1332 402 -1333 403 -1334 403 -1335 402 -1336 403 -1337 403 -1338 402 -1339 403 -1340 403 -1341 402 -1342 403 -1343 403 -1344 402 -1345 403 -1346 403 -1347 402 -1348 403 -1349 403 -1350 402 -1351 403 -1352 403 -1353 402 -1354 403 -1355 403 -1356 402 -1357 403 -1358 403 -1359 402 -1360 403 -1361 403 -1362 402 -1363 403 -1364 403 -1365 402 -1366 403 -1367 403 -1368 402 -1369 403 -1370 403 -1371 402 -1372 403 -1373 403 -1374 402 -1375 403 -1376 403 -1377 402 -1378 403 -1379 403 -1380 402 -1381 403 -1382 403 -1383 402 -1384 403 -1385 403 -1386 402 -1387 403 -1388 403 -1389 402 -1390 403 -1391 403 -1392 402 -1393 403 -1394 403 -1395 402 -1396 403 -1397 403 -1398 402 -1399 403 -1400 403 -1401 402 -1402 403 -1403 403 -1404 402 -1405 403 -1406 403 -1407 402 -1408 403 -1409 403 -1410 402 -1411 403 -1412 403 -1413 402 -1414 403 -1415 403 -1416 402 -1417 403 -1418 403 -1419 402 -1420 403 -1421 403 -1422 402 -1423 403 -1424 403 -1425 402 -1426 403 -1427 403 -1428 402 -1429 403 -1430 403 -1431 402 -1432 403 -1433 403 -1434 402 -1435 403 -1436 403 -1437 402 -1438 403 -1439 403 -1440 402 -1441 403 -1442 403 -1443 402 -1444 403 -1445 403 -1446 402 -1447 403 -1448 403 -1449 402 -1450 403 -1451 403 -1452 402 -1453 403 -1454 403 -1455 402 -1456 403 -1457 403 -1458 402 -1459 403 -1460 403 -1461 402 -1462 403 -1463 403 -1464 402 -1465 403 -1466 403 -1467 402 -1468 403 -1469 403 -1470 402 -1471 403 -1472 403 -1473 402 -1474 403 -1475 403 -1476 402 -1477 403 -1478 403 -1479 402 -1480 403 -1481 403 -1482 402 -1483 403 -1484 403 -1485 402 -1486 403 -1487 403 -1488 402 -1489 403 -1490 403 -1491 402 -1492 403 -1493 403 -1494 402 -1495 403 -1496 403 -1497 402 -1498 403 -1499 403 -1500 402 -1501 403 -1502 403 -1503 402 -1504 403 -1505 403 -1506 402 -1507 403 -1508 403 -1509 402 -1510 403 -1511 403 -1512 402 -1513 403 -1514 403 -1515 402 -1516 403 -1517 403 -1518 402 -1519 403 -1520 403 -1521 402 -1522 403 -1523 403 -1524 402 -1525 403 -1526 403 -1527 402 -1528 403 -1529 403 -1530 402 -1531 403 -1532 403 -1533 402 -1534 403 -1535 403 -1536 402 -1537 403 -1538 403 -1539 402 -1540 403 -1541 403 -1542 402 -1543 403 -1544 403 -1545 402 -1546 403 -1547 403 -1548 402 -1549 403 -1550 403 -1551 402 -1552 403 -1553 403 -1554 402 -1555 403 -1556 403 -1557 402 -1558 403 -1559 403 -1560 402 -1561 403 -1562 403 -1563 402 -1564 403 -1565 403 -1566 402 -1567 403 -1568 403 -1569 402 -1570 403 -1571 403 -1572 402 -1573 403 -1574 403 -1575 402 -1576 403 -1577 403 -1578 402 -1579 403 -1580 403 -1581 402 -1582 403 -1583 403 -1584 402 -1585 403 -1586 403 -1587 402 -1588 403 -1589 403 -1590 402 -1591 403 -1592 403 -1593 402 -1594 403 -1595 403 -1596 402 -1597 403 -1598 403 -1599 402 -1600 403 -1601 403 -1602 402 -1603 403 -1604 403 -1605 402 -1606 403 -1607 403 -1608 402 -1609 403 -1610 403 -1611 402 -1612 403 -1613 403 -1614 402 -1615 403 -1616 403 -1617 402 -1618 403 -1619 403 -1620 402 -1621 403 -1622 403 -1623 402 -1624 403 -1625 403 -1626 402 -1627 403 -1628 403 -1629 402 -1630 403 -1631 403 -1632 402 -1633 403 -1634 403 -1635 402 -1636 403 -1637 403 -1638 402 -1639 403 -1640 403 -1641 402 -1642 403 -1643 403 -1644 402 -1645 403 -1646 403 -1647 402 -1648 403 -1649 403 -1650 402 -1651 403 -1652 403 -1653 402 -1654 403 -1655 403 -1656 402 -1657 403 -1658 403 -1659 402 -1660 403 -1661 403 -1662 402 -1663 403 -1664 403 -1665 402 -1666 403 -1667 403 -1668 402 -1669 403 -1670 403 -1671 402 -1672 403 -1673 403 -1674 402 -1675 403 -1676 403 -1677 402 -1678 403 -1679 403 -1680 402 -1681 403 -1682 403 -1683 402 -1684 403 -1685 403 -1686 402 -1687 403 -1688 403 -1689 402 -1690 403 -1691 403 -1692 402 -1693 403 -1694 403 -1695 402 -1696 403 -1697 403 -1698 402 -1699 403 -1700 403 -1701 402 -1702 403 -1703 403 -1704 402 -1705 403 -1706 403 -1707 402 -1708 403 -1709 403 -1710 402 -1711 403 -1712 403 -1713 402 -1714 403 -1715 403 -1716 402 -1717 403 -1718 403 -1719 402 -1720 403 -1721 403 -1722 402 -1723 403 -1724 403 -1725 402 -1726 403 -1727 403 -1728 402 -1729 403 -1730 403 -1731 402 -1732 403 -1733 403 -1734 402 -1735 403 -1736 403 -1737 402 -1738 403 -1739 403 -1740 402 -1741 403 -1742 403 -1743 402 -1744 403 -1745 403 -1746 402 -1747 403 -1748 403 -1749 402 -1750 403 -1751 403 -1752 402 -1753 403 -1754 403 -1755 402 -1756 403 -1757 403 -1758 402 -1759 403 -1760 403 -1761 402 -1762 403 -1763 403 -1764 402 -1765 403 -1766 403 -1767 402 -1768 403 -1769 403 -1770 402 -1771 403 -1772 403 -1773 402 -1774 403 -1775 403 -1776 402 -1777 403 -1778 403 -1779 402 -1780 403 -1781 403 -1782 402 -1783 403 -1784 403 -1785 402 -1786 403 -1787 403 -1788 402 -1789 403 -1790 403 -1791 402 -1792 403 -1793 403 -1794 402 -1795 403 -1796 403 -1797 402 -1798 403 -1799 403 -1800 402 -1801 403 -1802 403 -1803 402 -1804 403 -1805 403 -1806 402 -1807 403 -1808 403 -1809 402 -1810 403 -1811 403 -1812 402 -1813 403 -1814 403 -1815 402 -1816 403 -1817 403 -1818 402 -1819 403 -1820 403 -1821 402 -1822 403 -1823 403 -1824 402 -1825 403 -1826 403 -1827 402 -1828 403 -1829 403 -1830 402 -1831 403 -1832 403 -1833 402 -1834 403 -1835 403 -1836 402 -1837 403 -1838 403 -1839 402 -1840 403 -1841 403 -1842 402 -1843 403 -1844 403 -1845 402 -1846 403 -1847 403 -1848 402 -1849 403 -1850 403 -1851 402 -1852 403 -1853 403 -1854 402 -1855 403 -1856 403 -1857 402 -1858 403 -1859 403 -1860 402 -1861 403 -1862 403 -1863 402 -1864 403 -1865 403 -1866 402 -1867 403 -1868 403 -1869 402 -1870 403 -1871 403 -1872 402 -1873 403 -1874 403 -1875 402 -1876 403 -1877 403 -1878 402 -1879 403 -1880 403 -1881 402 -1882 403 -1883 403 -1884 402 -1885 403 -1886 403 -1887 402 -1888 403 -1889 403 -1890 402 -1891 403 -1892 403 -1893 402 -1894 403 -1895 403 -1896 402 -1897 403 -1898 403 -1899 402 -1900 403 -1901 403 -1902 402 -1903 403 -1904 403 -1905 402 -1906 403 -1907 403 -1908 402 -1909 403 -1910 403 -1911 402 -1912 403 -1913 403 -1914 402 -1915 403 -1916 403 -1917 402 -1918 403 -1919 403 -1920 402 -1921 403 -1922 403 -1923 402 -1924 403 -1925 403 -1926 402 -1927 403 -1928 403 -1929 402 -1930 403 -1931 403 -1932 402 -1933 403 -1934 403 -1935 402 -1936 403 -1937 403 -1938 402 -1939 403 -1940 403 -1941 402 -1942 403 -1943 403 -1944 402 -1945 403 -1946 403 -1947 402 -1948 403 -1949 403 -1950 402 -1951 403 -1952 403 -1953 402 -1954 403 -1955 403 -1956 402 -1957 403 -1958 403 -1959 402 -1960 403 -1961 403 -1962 402 -1963 403 -1964 403 -1965 402 -1966 403 -1967 403 -1968 402 -1969 403 -1970 403 -1971 402 -1972 403 -1973 403 -1974 402 -1975 403 -1976 403 -1977 402 -1978 403 -1979 403 -1980 402 -1981 403 -1982 403 -1983 402 -1984 403 -1985 403 -1986 402 -1987 403 -1988 403 -1989 402 -1990 403 -1991 403 -1992 402 -1993 403 -1994 403 -1995 402 -1996 403 -1997 403 -1998 402 -1999 403 -2000 403 -2001 402 -2002 403 -2003 403 -2004 402 -2005 403 -2006 403 -2007 402 -2008 403 -2009 403 -2010 402 -2011 403 -2012 403 -2013 402 -2014 403 -2015 403 -2016 402 -2017 403 -2018 403 -2019 402 -2020 403 -2021 403 -2022 402 -2023 403 -2024 403 -2025 402 -2026 403 -2027 403 -2028 402 -2029 403 -2030 403 -2031 402 -2032 403 -2033 403 -2034 402 -2035 403 -2036 403 -2037 402 -2038 403 -2039 403 -2040 402 -2041 403 -2042 403 -2043 402 -2044 403 -2045 403 -2046 402 -2047 403 -2048 403 -2049 402 -2050 403 -2051 403 -2052 402 -2053 403 -2054 403 -2055 402 -2056 403 -2057 403 -2058 402 -2059 403 -2060 403 -2061 402 -2062 403 -2063 403 -2064 402 -2065 403 -2066 403 -2067 402 -2068 403 -2069 403 -2070 402 -2071 403 -2072 403 -2073 402 -2074 403 -2075 403 -2076 402 -2077 403 -2078 403 -2079 402 -2080 403 -2081 403 -2082 402 -2083 403 -2084 403 -2085 402 -2086 403 -2087 403 -2088 402 -2089 403 -2090 403 -2091 402 -2092 403 -2093 403 -2094 402 -2095 403 -2096 403 -2097 402 -2098 403 -2099 403 -2100 402 -2101 403 -2102 403 -2103 402 -2104 403 -2105 403 -2106 402 -2107 403 -2108 403 -2109 402 -2110 403 -2111 403 -2112 402 -2113 403 -2114 403 -2115 402 -2116 403 -2117 403 -2118 402 -2119 403 -2120 403 -2121 402 -2122 403 -2123 403 -2124 402 -2125 403 -2126 403 -2127 402 -2128 403 -2129 403 -2130 402 -2131 403 -2132 403 -2133 402 -2134 403 -2135 403 -2136 402 -2137 403 -2138 403 -2139 402 -2140 403 -2141 403 -2142 402 -2143 403 -2144 403 -2145 402 -2146 403 -2147 403 -2148 402 -2149 403 -2150 403 -2151 402 -2152 403 -2153 403 -2154 402 -2155 403 -2156 403 -2157 402 -2158 403 -2159 403 -2160 402 -2161 403 -2162 403 -2163 402 -2164 403 -2165 403 -2166 402 -2167 403 -2168 403 -2169 402 -2170 403 -2171 403 -2172 402 -2173 403 -2174 403 -2175 402 -2176 403 -2177 403 -2178 402 -2179 403 -2180 403 -2181 402 -2182 403 -2183 403 -2184 402 -2185 403 -2186 403 -2187 402 -2188 403 -2189 403 -2190 402 -2191 403 -2192 403 -2193 402 -2194 403 -2195 403 -2196 402 -2197 403 -2198 403 -2199 402 -2200 403 -2201 403 -2202 402 -2203 403 -2204 403 -2205 402 -2206 403 -2207 403 -2208 402 -2209 403 -2210 403 -2211 402 -2212 403 -2213 403 -2214 402 -2215 403 -2216 403 -2217 402 -2218 403 -2219 403 -2220 402 -2221 403 -2222 403 -2223 402 -2224 403 -2225 403 -2226 402 -2227 403 -2228 403 -2229 402 -2230 403 -2231 403 -2232 402 -2233 403 -2234 403 -2235 402 -2236 403 -2237 403 -2238 402 -2239 403 -2240 403 -2241 402 -2242 403 -2243 403 -2244 402 -2245 403 -2246 403 -2247 402 -2248 403 -2249 403 -2250 402 -2251 403 -2252 403 -2253 402 -2254 403 -2255 403 -2256 402 -2257 403 -2258 403 -2259 402 -2260 403 -2261 403 -2262 402 -2263 403 -2264 403 -2265 402 -2266 403 -2267 403 -2268 402 -2269 403 -2270 403 -2271 402 -2272 403 -2273 403 -2274 402 -2275 403 -2276 403 -2277 402 -2278 403 -2279 403 -2280 402 -2281 403 -2282 403 -2283 402 -2284 403 -2285 403 -2286 402 -2287 403 -2288 403 -2289 402 -2290 403 -2291 403 -2292 402 -2293 403 -2294 403 -2295 402 -2296 403 -2297 403 -2298 402 -2299 403 -2300 403 -2301 402 -2302 403 -2303 403 -2304 402 -2305 403 -2306 403 -2307 402 -2308 403 -2309 403 -2310 402 -2311 403 -2312 403 -2313 402 -2314 403 -2315 403 -2316 402 -2317 403 -2318 403 -2319 402 -2320 403 -2321 403 -2322 402 -2323 403 -2324 403 -2325 402 -2326 403 -2327 403 -2328 402 -2329 403 -2330 403 -2331 402 -2332 403 -2333 403 -2334 402 -2335 403 -2336 403 -2337 402 -2338 403 -2339 403 -2340 402 -2341 403 -2342 403 -2343 402 -2344 403 -2345 403 -2346 402 -2347 403 -2348 403 -2349 402 -2350 403 -2351 403 -2352 402 -2353 403 -2354 403 -2355 402 -2356 403 -2357 403 -2358 402 -2359 403 -2360 403 -2361 402 -2362 403 -2363 403 -2364 402 -2365 403 -2366 403 -2367 402 -2368 403 -2369 403 -2370 402 -2371 403 -2372 403 -2373 402 -2374 403 -2375 403 -2376 402 -2377 403 -2378 403 -2379 402 -2380 403 -2381 403 -2382 402 -2383 403 -2384 403 -2385 402 -2386 403 -2387 403 -2388 402 -2389 403 -2390 403 -2391 402 -2392 403 -2393 403 -2394 402 -2395 403 -2396 403 -2397 402 -2398 403 -2399 403 -2400 402 -2401 403 -2402 403 -2403 402 -2404 403 -2405 403 -2406 402 -2407 403 -2408 403 -2409 402 -2410 403 -2411 403 -2412 402 -2413 403 -2414 403 -2415 402 -2416 403 -2417 403 -2418 402 -2419 403 -2420 403 -2421 402 -2422 403 -2423 403 -2424 402 -2425 403 -2426 403 -2427 402 -2428 403 -2429 403 -2430 402 -2431 403 -2432 403 -2433 402 -2434 403 -2435 403 -2436 402 -2437 403 -2438 403 -2439 402 -2440 403 -2441 403 -2442 402 -2443 403 -2444 403 -2445 402 -2446 403 -2447 403 -2448 402 -2449 403 -2450 403 -2451 402 -2452 403 -2453 403 -2454 402 -2455 403 -2456 403 -2457 402 -2458 403 -2459 403 -2460 402 -2461 403 -2462 403 -2463 402 -2464 403 -2465 403 -2466 402 -2467 403 -2468 403 -2469 402 -2470 403 -2471 403 -2472 402 -2473 403 -2474 403 -2475 402 -2476 403 -2477 403 -2478 402 -2479 403 -2480 403 -2481 402 -2482 403 -2483 403 -2484 402 -2485 403 -2486 403 -2487 402 -2488 403 -2489 403 -2490 402 -2491 403 -2492 403 -2493 402 -2494 403 -2495 403 -2496 402 -2497 403 -2498 403 -2499 402 -2500 403 -2501 403 -2502 402 -2503 403 -2504 403 -2505 402 -2506 403 -2507 403 -2508 402 -2509 403 -2510 403 -2511 402 -2512 403 -2513 403 -2514 402 -2515 403 -2516 403 -2517 402 -2518 403 -2519 403 -2520 402 -2521 403 -2522 403 -2523 402 -2524 403 -2525 403 -2526 402 -2527 403 -2528 403 -2529 402 -2530 403 -2531 403 -2532 402 -2533 403 -2534 403 -2535 402 -2536 403 -2537 403 -2538 402 -2539 403 -2540 403 -2541 402 -2542 403 -2543 403 -2544 402 -2545 403 -2546 403 -2547 402 -2548 403 -2549 403 -2550 402 -2551 403 -2552 403 -2553 402 -2554 403 -2555 403 -2556 402 -2557 403 -2558 403 -2559 402 -2560 403 -2561 403 -2562 402 -2563 403 -2564 403 -2565 402 -2566 403 -2567 403 -2568 402 -2569 403 -2570 403 -2571 402 -2572 403 -2573 403 -2574 402 -2575 403 -2576 403 -2577 402 -2578 403 -2579 403 -2580 402 -2581 403 -2582 403 -2583 402 -2584 403 -2585 403 -2586 402 -2587 403 -2588 403 -2589 402 -2590 403 -2591 403 -2592 402 -2593 403 -2594 403 -2595 402 -2596 403 -2597 403 -2598 402 -2599 403 -2600 403 -2601 402 -2602 403 -2603 403 -2604 402 -2605 403 -2606 403 -2607 402 -2608 403 -2609 403 -2610 402 -2611 403 -2612 403 -2613 402 -2614 403 -2615 403 -2616 402 -2617 403 -2618 403 -2619 402 -2620 403 -2621 403 -2622 402 -2623 403 -2624 403 -2625 402 -2626 403 -2627 403 -2628 402 -2629 403 -2630 403 -2631 402 -2632 403 -2633 403 -2634 402 -2635 403 -2636 403 -2637 402 -2638 403 -2639 403 -2640 402 -2641 403 -2642 403 -2643 402 -2644 403 -2645 403 -2646 402 -2647 403 -2648 403 -2649 402 -2650 403 -2651 403 -2652 402 -2653 403 -2654 403 -2655 402 -2656 403 -2657 403 -2658 402 -2659 403 -2660 403 -2661 402 -2662 403 -2663 403 -2664 402 -2665 403 -2666 403 -2667 402 -2668 403 -2669 403 -2670 402 -2671 403 -2672 403 -2673 402 -2674 403 -2675 403 -2676 402 -2677 403 -2678 403 -2679 402 -2680 403 -2681 403 -2682 402 -2683 403 -2684 403 -2685 402 -2686 403 -2687 403 -2688 402 -2689 403 -2690 403 -2691 402 -2692 403 -2693 403 -2694 402 -2695 403 -2696 403 -2697 402 -2698 403 -2699 403 -2700 402 -2701 403 -2702 403 -2703 402 -2704 403 -2705 403 -2706 402 -2707 403 -2708 403 -2709 402 -2710 403 -2711 403 -2712 402 -2713 403 -2714 403 -2715 402 -2716 403 -2717 403 -2718 402 -2719 403 -2720 403 -2721 402 -2722 403 -2723 403 -2724 402 -2725 403 -2726 403 -2727 402 -2728 403 -2729 403 -2730 402 -2731 403 -2732 403 -2733 402 -2734 403 -2735 403 -2736 402 -2737 403 -2738 403 -2739 402 -2740 403 -2741 403 -2742 402 -2743 403 -2744 403 -2745 402 -2746 403 -2747 403 -2748 402 -2749 403 -2750 403 -2751 402 -2752 403 -2753 403 -2754 402 -2755 403 -2756 403 -2757 402 -2758 403 -2759 403 -2760 402 -2761 403 -2762 403 -2763 402 -2764 403 -2765 403 -2766 402 -2767 403 -2768 403 -2769 402 -2770 403 -2771 403 -2772 402 -2773 403 -2774 403 -2775 402 -2776 403 -2777 403 -2778 402 -2779 403 -2780 403 -2781 402 -2782 403 -2783 403 -2784 402 -2785 403 -2786 403 -2787 402 -2788 403 -2789 403 -2790 402 -2791 403 -2792 403 -2793 402 -2794 403 -2795 403 -2796 402 -2797 403 -2798 403 -2799 402 -2800 403 -2801 403 -2802 402 -2803 403 -2804 403 -2805 402 -2806 403 -2807 403 -2808 402 -2809 403 -2810 403 -2811 402 -2812 403 -2813 403 -2814 402 -2815 403 -2816 403 -2817 402 -2818 403 -2819 403 -2820 402 -2821 403 -2822 403 -2823 402 -2824 403 -2825 403 -2826 402 -2827 403 -2828 403 -2829 402 -2830 403 -2831 403 -2832 402 -2833 403 -2834 403 -2835 402 -2836 403 -2837 403 -2838 402 -2839 403 -2840 403 -2841 402 -2842 403 -2843 403 -2844 402 -2845 403 -2846 403 -2847 402 -2848 403 -2849 403 -2850 402 -2851 403 -2852 403 -2853 402 -2854 403 -2855 403 -2856 402 -2857 403 -2858 403 -2859 402 -2860 403 -2861 403 -2862 402 -2863 403 -2864 403 -2865 402 -2866 403 -2867 403 -2868 402 -2869 403 -2870 403 -2871 402 -2872 403 -2873 403 -2874 402 -2875 403 -2876 403 -2877 402 -2878 403 -2879 403 -2880 402 -2881 403 -2882 403 -2883 402 -2884 403 -2885 403 -2886 402 -2887 403 -2888 403 -2889 402 -2890 403 -2891 403 -2892 402 -2893 403 -2894 403 -2895 402 -2896 403 -2897 403 -2898 402 -2899 403 -2900 403 -2901 402 -2902 403 -2903 403 -2904 402 -2905 403 -2906 403 -2907 402 -2908 403 -2909 403 -2910 402 -2911 403 -2912 403 -2913 402 -2914 403 -2915 403 -2916 402 -2917 403 -2918 403 -2919 402 -2920 403 -2921 403 -2922 402 -2923 403 -2924 403 -2925 402 -2926 403 -2927 403 -2928 402 -2929 403 -2930 403 -2931 402 -2932 403 -2933 403 -2934 402 -2935 403 -2936 403 -2937 402 -2938 403 -2939 403 -2940 402 -2941 403 -2942 403 -2943 402 -2944 403 -2945 403 -2946 402 -2947 403 -2948 403 -2949 402 -2950 403 -2951 403 -2952 402 -2953 403 -2954 403 -2955 402 -2956 403 -2957 403 -2958 402 -2959 403 -2960 403 -2961 402 -2962 403 -2963 403 -2964 402 -2965 403 -2966 403 -2967 402 -2968 403 -2969 403 -2970 402 -2971 403 -2972 403 -2973 402 -2974 403 -2975 403 -2976 402 -2977 403 -2978 403 -2979 402 -2980 403 -2981 403 -2982 402 -2983 403 -2984 403 -2985 402 -2986 403 -2987 403 -2988 402 -2989 403 -2990 403 -2991 402 -2992 403 -2993 403 -2994 402 -2995 403 -2996 403 -2997 402 -2998 403 -2999 403 -3000 402 -3001 403 -3002 403 -3003 402 -3004 403 -3005 403 -3006 402 -3007 403 -3008 403 -3009 402 -3010 403 -3011 403 -3012 402 -3013 403 -3014 403 -3015 402 -3016 403 -3017 403 -3018 402 -3019 403 -3020 403 -3021 402 -3022 403 -3023 403 -3024 402 -3025 403 -3026 403 -3027 402 -3028 403 -3029 403 -3030 402 -3031 403 -3032 403 -3033 402 -3034 403 -3035 403 -3036 402 -3037 403 -3038 403 -3039 402 -3040 403 -3041 403 -3042 402 -3043 403 -3044 403 -3045 402 -3046 403 -3047 403 -3048 402 -3049 403 -3050 403 -3051 402 -3052 403 -3053 403 -3054 402 -3055 403 -3056 403 -3057 402 -3058 403 -3059 403 -3060 402 -3061 403 -3062 403 -3063 402 -3064 403 -3065 403 -3066 402 -3067 403 -3068 403 -3069 402 -3070 403 -3071 403 -3072 402 -3073 403 -3074 403 -3075 402 -3076 403 -3077 403 -3078 402 -3079 403 -3080 403 -3081 402 -3082 403 -3083 403 -3084 402 -3085 403 -3086 403 -3087 402 -3088 403 -3089 403 -3090 402 -3091 403 -3092 403 -3093 402 -3094 403 -3095 403 -3096 402 -3097 403 -3098 403 -3099 402 -3100 403 -3101 403 -3102 402 -3103 403 -3104 403 -3105 402 -3106 403 -3107 403 -3108 402 -3109 403 -3110 403 -3111 402 -3112 403 -3113 403 -3114 402 -3115 403 -3116 403 -3117 402 -3118 403 -3119 403 -3120 402 -3121 403 -3122 403 -3123 402 -3124 403 -3125 403 -3126 402 -3127 403 -3128 403 -3129 402 -3130 403 -3131 403 -3132 402 -3133 403 -3134 403 -3135 402 -3136 403 -3137 403 -3138 402 -3139 403 -3140 403 -3141 402 -3142 403 -3143 403 -3144 402 -3145 403 -3146 403 -3147 402 -3148 403 -3149 403 -3150 402 -3151 403 -3152 403 -3153 402 -3154 403 -3155 403 -3156 402 -3157 403 -3158 403 -3159 402 -3160 403 -3161 403 -3162 402 -3163 403 -3164 403 -3165 402 -3166 403 -3167 403 -3168 402 -3169 403 -3170 403 -3171 402 -3172 403 -3173 403 -3174 402 -3175 403 -3176 403 -3177 402 -3178 403 -3179 403 -3180 402 -3181 403 -3182 403 -3183 402 -3184 403 -3185 403 -3186 402 -3187 403 -3188 403 -3189 402 -3190 403 -3191 403 -3192 402 -3193 403 -3194 403 -3195 402 -3196 403 -3197 403 -3198 402 -3199 403 -3200 403 -3201 402 -3202 403 -3203 403 -3204 402 -3205 403 -3206 403 -3207 402 -3208 403 -3209 403 -3210 402 -3211 403 -3212 403 -3213 402 -3214 403 -3215 403 -3216 402 -3217 403 -3218 403 -3219 402 -3220 403 -3221 403 -3222 402 -3223 403 -3224 403 -3225 402 -3226 403 -3227 403 -3228 402 -3229 403 -3230 403 -3231 402 -3232 403 -3233 403 -3234 402 -3235 403 -3236 403 -3237 402 -3238 403 -3239 403 -3240 402 -3241 403 -3242 403 -3243 402 -3244 403 -3245 403 -3246 402 -3247 403 -3248 403 -3249 402 -3250 403 -3251 403 -3252 402 -3253 403 -3254 403 -3255 402 -3256 403 -3257 403 -3258 402 -3259 403 -3260 403 -3261 402 -3262 403 -3263 403 -3264 402 -3265 403 -3266 403 -3267 402 -3268 403 -3269 403 -3270 402 -3271 403 -3272 403 -3273 402 -3274 403 -3275 403 -3276 402 -3277 403 -3278 403 -3279 402 -3280 403 -3281 403 -3282 402 -3283 403 -3284 403 -3285 402 -3286 403 -3287 403 -3288 402 -3289 403 -3290 403 -3291 402 -3292 403 -3293 403 -3294 402 -3295 403 -3296 403 -3297 402 -3298 403 -3299 403 -3300 402 -3301 403 -3302 403 -3303 402 -3304 403 -3305 403 -3306 402 -3307 403 -3308 403 -3309 402 -3310 403 -3311 403 -3312 402 -3313 403 -3314 403 -3315 402 -3316 403 -3317 403 -3318 402 -3319 403 -3320 403 -3321 402 -3322 403 -3323 403 -3324 402 -3325 403 -3326 403 -3327 402 -3328 403 -3329 403 -3330 402 -3331 403 -3332 403 -3333 402 -3334 403 -3335 403 -3336 402 -3337 403 -3338 403 -3339 402 -3340 403 -3341 403 -3342 402 -3343 403 -3344 403 -3345 402 -3346 403 -3347 403 -3348 402 -3349 403 -3350 403 -3351 402 -3352 403 -3353 403 -3354 402 -3355 403 -3356 403 -3357 402 -3358 403 -3359 403 -3360 402 -3361 403 -3362 403 -3363 402 -3364 403 -3365 403 -3366 402 -3367 403 -3368 403 -3369 402 -3370 403 -3371 403 -3372 402 -3373 403 -3374 403 -3375 402 -3376 403 -3377 403 -3378 402 -3379 403 -3380 403 -3381 402 -3382 403 -3383 403 -3384 402 -3385 403 -3386 403 -3387 402 -3388 403 -3389 403 -3390 402 -3391 403 -3392 403 -3393 402 -3394 403 -3395 403 -3396 402 -3397 403 -3398 403 -3399 402 -3400 403 -3401 403 -3402 402 -3403 403 -3404 403 -3405 402 -3406 403 -3407 403 -3408 402 -3409 403 -3410 403 -3411 402 -3412 403 -3413 403 -3414 402 -3415 403 -3416 403 -3417 402 -3418 403 -3419 403 -3420 402 -3421 403 -3422 403 -3423 402 -3424 403 -3425 403 -3426 402 -3427 403 -3428 403 -3429 402 -3430 403 -3431 403 -3432 402 -3433 403 -3434 403 -3435 402 -3436 403 -3437 403 -3438 402 -3439 403 -3440 403 -3441 402 -3442 403 -3443 403 -3444 402 -3445 403 -3446 403 -3447 402 -3448 403 -3449 403 -3450 402 -3451 403 -3452 403 -3453 402 -3454 403 -3455 403 -3456 402 -3457 403 -3458 403 -3459 402 -3460 403 -3461 403 -3462 402 -3463 403 -3464 403 -3465 402 -3466 403 -3467 403 -3468 402 -3469 403 -3470 403 -3471 402 -3472 403 -3473 403 -3474 402 -3475 403 -3476 403 -3477 402 -3478 403 -3479 403 -3480 402 -3481 403 -3482 403 -3483 402 -3484 403 -3485 403 -3486 402 -3487 403 -3488 403 -3489 402 -3490 403 -3491 403 -3492 402 -3493 403 -3494 403 -3495 402 -3496 403 -3497 403 -3498 402 -3499 403 -3500 403 -3501 402 -3502 403 -3503 403 -3504 402 -3505 403 -3506 403 -3507 402 -3508 403 -3509 403 -3510 402 -3511 403 -3512 403 -3513 402 -3514 403 -3515 403 -3516 402 -3517 403 -3518 403 -3519 402 -3520 403 -3521 403 -3522 402 -3523 403 -3524 403 -3525 402 -3526 403 -3527 403 -3528 402 -3529 403 -3530 403 -3531 402 -3532 403 -3533 403 -3534 402 -3535 403 -3536 403 -3537 402 -3538 403 -3539 403 -3540 402 -3541 403 -3542 403 -3543 402 -3544 403 -3545 403 -3546 402 -3547 403 -3548 403 -3549 402 -3550 403 -3551 403 -3552 402 -3553 403 -3554 403 -3555 402 -3556 403 -3557 403 -3558 402 -3559 403 -3560 403 -3561 402 -3562 403 -3563 403 -3564 402 -3565 403 -3566 403 -3567 402 -3568 403 -3569 403 -3570 402 -3571 403 -3572 403 -3573 402 -3574 403 -3575 403 -3576 402 -3577 403 -3578 403 -3579 402 -3580 403 -3581 403 -3582 402 -3583 403 -3584 403 -3585 402 -3586 403 -3587 403 -3588 402 -3589 403 -3590 403 -3591 402 -3592 403 -3593 403 -3594 402 -3595 403 -3596 403 -3597 402 -3598 403 -3599 403 -3600 402 -3601 403 -3602 403 -3603 402 -3604 403 -3605 403 -3606 402 -3607 403 -3608 403 -3609 402 -3610 403 -3611 403 -3612 402 -3613 403 -3614 403 -3615 402 -3616 403 -3617 403 -3618 402 -3619 403 -3620 403 -3621 402 -3622 403 -3623 403 -3624 402 -3625 403 -3626 403 -3627 402 -3628 403 -3629 403 -3630 402 -3631 403 -3632 403 -3633 402 -3634 403 -3635 403 -3636 402 -3637 403 -3638 403 -3639 402 -3640 403 -3641 403 -3642 402 -3643 403 -3644 403 -3645 402 -3646 403 -3647 403 -3648 402 -3649 403 -3650 403 -3651 402 -3652 403 -3653 403 -3654 402 -3655 403 -3656 403 -3657 402 -3658 403 -3659 403 -3660 402 -3661 403 -3662 403 -3663 402 -3664 403 -3665 403 -3666 402 -3667 403 -3668 403 -3669 402 -3670 403 -3671 403 -3672 402 -3673 403 -3674 403 -3675 402 -3676 403 -3677 403 -3678 402 -3679 403 -3680 403 -3681 402 -3682 403 -3683 403 -3684 402 -3685 403 -3686 403 -3687 402 -3688 403 -3689 403 -3690 402 -3691 403 -3692 403 -3693 402 -3694 403 -3695 403 -3696 402 -3697 403 -3698 403 -3699 402 -3700 403 -3701 403 -3702 402 -3703 403 -3704 403 -3705 402 -3706 403 -3707 403 -3708 402 -3709 403 -3710 403 -3711 402 -3712 403 -3713 403 -3714 402 -3715 403 -3716 403 -3717 402 -3718 403 -3719 403 -3720 402 -3721 403 -3722 403 -3723 402 -3724 403 -3725 403 -3726 402 -3727 403 -3728 403 -3729 402 -3730 403 -3731 403 -3732 402 -3733 403 -3734 403 -3735 402 -3736 403 -3737 403 -3738 402 -3739 403 -3740 403 -3741 402 -3742 403 -3743 403 -3744 402 -3745 403 -3746 403 -3747 402 -3748 403 -3749 403 -3750 402 -3751 403 -3752 403 -3753 402 -3754 403 -3755 403 -3756 402 -3757 403 -3758 403 -3759 402 -3760 403 -3761 403 -3762 402 -3763 403 -3764 403 -3765 402 -3766 403 -3767 403 -3768 402 -3769 403 -3770 403 -3771 402 -3772 403 -3773 403 -3774 402 -3775 403 -3776 403 -3777 402 -3778 403 -3779 403 -3780 402 -3781 403 -3782 403 -3783 402 -3784 403 -3785 403 -3786 402 -3787 403 -3788 403 -3789 402 -3790 403 -3791 403 -3792 402 -3793 403 -3794 403 -3795 402 -3796 403 -3797 403 -3798 402 -3799 403 -3800 403 -3801 402 -3802 403 -3803 403 -3804 402 -3805 403 -3806 403 -3807 402 -3808 403 -3809 403 -3810 402 -3811 403 -3812 403 -3813 402 -3814 403 -3815 403 -3816 402 -3817 403 -3818 403 -3819 402 -3820 403 -3821 403 -3822 402 -3823 403 -3824 403 -3825 402 -3826 403 -3827 403 -3828 402 -3829 403 -3830 403 -3831 402 -3832 403 -3833 403 -3834 402 -3835 403 -3836 403 -3837 402 -3838 403 -3839 403 -3840 402 -3841 403 -3842 403 -3843 402 -3844 403 -3845 403 -3846 402 -3847 403 -3848 403 -3849 402 -3850 403 -3851 403 -3852 402 -3853 403 -3854 403 -3855 402 -3856 403 -3857 403 -3858 402 -3859 403 -3860 403 -3861 402 -3862 403 -3863 403 -3864 402 -3865 403 -3866 403 -3867 402 -3868 403 -3869 403 -3870 402 -3871 403 -3872 403 -3873 402 -3874 403 -3875 403 -3876 402 -3877 403 -3878 403 -3879 402 -3880 403 -3881 403 -3882 402 -3883 403 -3884 403 -3885 402 -3886 403 -3887 403 -3888 402 -3889 403 -3890 403 -3891 402 -3892 403 -3893 403 -3894 402 -3895 403 -3896 403 -3897 402 -3898 403 -3899 403 -3900 402 -3901 403 -3902 403 -3903 402 -3904 403 -3905 403 -3906 402 -3907 403 -3908 403 -3909 402 -3910 403 -3911 403 -3912 402 -3913 403 -3914 403 -3915 402 -3916 403 -3917 403 -3918 402 -3919 403 -3920 403 -3921 402 -3922 403 -3923 403 -3924 402 -3925 403 -3926 403 -3927 402 -3928 403 -3929 403 -3930 402 -3931 403 -3932 403 -3933 402 -3934 403 -3935 403 -3936 402 -3937 403 -3938 403 -3939 402 -3940 403 -3941 403 -3942 402 -3943 403 -3944 403 -3945 402 -3946 403 -3947 403 -3948 402 -3949 403 -3950 403 -3951 402 -3952 403 -3953 403 -3954 402 -3955 403 -3956 403 -3957 402 -3958 403 -3959 403 -3960 402 -3961 403 -3962 403 -3963 402 -3964 403 -3965 403 -3966 402 -3967 403 -3968 403 -3969 402 -3970 403 -3971 403 -3972 402 -3973 403 -3974 403 -3975 402 -3976 403 -3977 403 -3978 402 -3979 403 -3980 403 -3981 402 -3982 403 -3983 403 -3984 402 -3985 403 -3986 403 -3987 402 -3988 403 -3989 403 -3990 402 -3991 403 -3992 403 -3993 402 -3994 403 -3995 403 -3996 402 -3997 403 -3998 403 -3999 402 -4000 403 -4001 403 -4002 402 -4003 403 -4004 403 -4005 402 -4006 403 -4007 403 -4008 402 -4009 403 -4010 403 -4011 402 -4012 403 -4013 403 -4014 402 -4015 403 -4016 403 -4017 402 -4018 403 -4019 403 -4020 402 -4021 403 -4022 403 -4023 402 -4024 403 -4025 403 -4026 402 -4027 403 -4028 403 -4029 402 -4030 403 -4031 403 -4032 402 -4033 403 -4034 403 -4035 402 -4036 403 -4037 403 -4038 402 -4039 403 -4040 403 -4041 402 -4042 403 -4043 403 -4044 402 -4045 403 -4046 403 -4047 402 -4048 403 -4049 403 -4050 402 -4051 403 -4052 403 -4053 402 -4054 403 -4055 403 -4056 402 -4057 403 -4058 403 -4059 402 -4060 403 -4061 403 -4062 402 -4063 403 -4064 403 -4065 402 -4066 403 -4067 403 -4068 402 -4069 403 -4070 403 -4071 402 -4072 403 -4073 403 -4074 402 -4075 403 -4076 403 -4077 402 -4078 403 -4079 403 -4080 402 -4081 403 -4082 403 -4083 402 -4084 403 -4085 403 -4086 402 -4087 403 -4088 403 -4089 402 -4090 403 -4091 403 -4092 402 -4093 403 -4094 403 -4095 402 -4096 403 -4097 403 -4098 402 -4099 403 -4100 403 -4101 402 -4102 403 -4103 403 -4104 402 -4105 403 -4106 403 -4107 402 -4108 403 -4109 403 -4110 402 -4111 403 -4112 403 -4113 402 -4114 403 -4115 403 -4116 402 -4117 403 -4118 403 -4119 402 -4120 403 -4121 403 -4122 402 -4123 403 -4124 403 -4125 402 -4126 403 -4127 403 -4128 402 -4129 403 -4130 403 -4131 402 -4132 403 -4133 403 -4134 402 -4135 403 -4136 403 -4137 402 -4138 403 -4139 403 -4140 402 -4141 403 -4142 403 -4143 402 -4144 403 -4145 403 -4146 402 -4147 403 -4148 403 -4149 402 -4150 403 -4151 403 -4152 402 -4153 403 -4154 403 -4155 402 -4156 403 -4157 403 -4158 402 -4159 403 -4160 403 -4161 402 -4162 403 -4163 403 -4164 402 -4165 403 -4166 403 -4167 402 -4168 403 -4169 403 -4170 402 -4171 403 -4172 403 -4173 402 -4174 403 -4175 403 -4176 402 -4177 403 -4178 403 -4179 402 -4180 403 -4181 403 -4182 402 -4183 403 -4184 403 -4185 402 -4186 403 -4187 403 -4188 402 -4189 403 -4190 403 -4191 402 -4192 403 -4193 403 -4194 402 -4195 403 -4196 403 -4197 402 -4198 403 -4199 403 -4200 402 -4201 403 -4202 403 -4203 402 -4204 403 -4205 403 -4206 402 -4207 403 -4208 403 -4209 402 -4210 403 -4211 403 -4212 402 -4213 403 -4214 403 -4215 402 -4216 403 -4217 403 -4218 402 -4219 403 -4220 403 -4221 402 -4222 403 -4223 403 -4224 402 -4225 403 -4226 403 -4227 402 -4228 403 -4229 403 -4230 402 -4231 403 -4232 403 -4233 402 -4234 403 -4235 403 -4236 402 -4237 403 -4238 403 -4239 402 -4240 403 -4241 403 -4242 402 -4243 403 -4244 403 -4245 402 -4246 403 -4247 403 -4248 402 -4249 403 -4250 403 -4251 402 -4252 403 -4253 403 -4254 402 -4255 403 -4256 403 -4257 402 -4258 403 -4259 403 -4260 402 -4261 403 -4262 403 -4263 402 -4264 403 -4265 403 -4266 402 -4267 403 -4268 403 -4269 402 -4270 403 -4271 403 -4272 402 -4273 403 -4274 403 -4275 402 -4276 403 -4277 403 -4278 402 -4279 403 -4280 403 -4281 402 -4282 403 -4283 403 -4284 402 -4285 403 -4286 403 -4287 402 -4288 403 -4289 403 -4290 402 -4291 403 -4292 403 -4293 402 -4294 403 -4295 403 -4296 402 -4297 403 -4298 403 -4299 402 -4300 403 -4301 403 -4302 402 -4303 403 -4304 403 -4305 402 -4306 403 -4307 403 -4308 402 -4309 403 -4310 403 -4311 402 -4312 403 -4313 403 -4314 402 -4315 403 -4316 403 -4317 402 -4318 403 -4319 403 -4320 402 -4321 403 -4322 403 -4323 402 -4324 403 -4325 403 -4326 402 -4327 403 -4328 403 -4329 402 -4330 403 -4331 403 -4332 402 -4333 403 -4334 403 -4335 402 -4336 403 -4337 403 -4338 402 -4339 403 -4340 403 -4341 402 -4342 403 -4343 403 -4344 402 -4345 403 -4346 403 -4347 402 -4348 403 -4349 403 -4350 402 -4351 403 -4352 403 -4353 402 -4354 403 -4355 403 -4356 402 -4357 403 -4358 403 -4359 402 -4360 403 -4361 403 -4362 402 -4363 403 -4364 403 -4365 402 -4366 403 -4367 403 -4368 402 -4369 403 -4370 403 -4371 402 -4372 403 -4373 403 -4374 402 -4375 403 -4376 403 -4377 402 -4378 403 -4379 403 -4380 402 -4381 403 -4382 403 -4383 402 -4384 403 -4385 403 -4386 402 -4387 403 -4388 403 -4389 402 -4390 403 -4391 403 -4392 402 -4393 403 -4394 403 -4395 402 -4396 403 -4397 403 -4398 402 -4399 403 -4400 403 -4401 402 -4402 403 -4403 403 -4404 402 -4405 403 -4406 403 -4407 402 -4408 403 -4409 403 -4410 402 -4411 403 -4412 403 -4413 402 -4414 403 -4415 403 -4416 402 -4417 403 -4418 403 -4419 402 -4420 403 -4421 403 -4422 402 -4423 403 -4424 403 -4425 402 -4426 403 -4427 403 -4428 402 -4429 403 -4430 403 -4431 402 -4432 403 -4433 403 -4434 402 -4435 403 -4436 403 -4437 402 -4438 403 -4439 403 -4440 402 -4441 403 -4442 403 -4443 402 -4444 403 -4445 403 -4446 402 -4447 403 -4448 403 -4449 402 -4450 403 -4451 403 -4452 402 -4453 403 -4454 403 -4455 402 -4456 403 -4457 403 -4458 402 -4459 403 -4460 403 -4461 402 -4462 403 -4463 403 -4464 402 -4465 403 -4466 403 -4467 402 -4468 403 -4469 403 -4470 402 -4471 403 -4472 403 -4473 402 -4474 403 -4475 403 -4476 402 -4477 403 -4478 403 -4479 402 -4480 403 -4481 403 -4482 402 -4483 403 -4484 403 -4485 402 -4486 403 -4487 403 -4488 402 -4489 403 -4490 403 -4491 402 -4492 403 -4493 403 -4494 402 -4495 403 -4496 403 -4497 402 -4498 403 -4499 403 -4500 402 -4501 403 -4502 403 -4503 402 -4504 403 -4505 403 -4506 402 -4507 403 -4508 403 -4509 402 -4510 403 -4511 403 -4512 402 -4513 403 -4514 403 -4515 402 -4516 403 -4517 403 -4518 402 -4519 403 -4520 403 -4521 402 -4522 403 -4523 403 -4524 402 -4525 403 -4526 403 -4527 402 -4528 403 -4529 403 -4530 402 -4531 403 -4532 403 -4533 402 -4534 403 -4535 403 -4536 402 -4537 403 -4538 403 -4539 402 -4540 403 -4541 403 -4542 402 -4543 403 -4544 403 -4545 402 -4546 403 -4547 403 -4548 402 -4549 403 -4550 403 -4551 402 -4552 403 -4553 403 -4554 402 -4555 403 -4556 403 -4557 402 -4558 403 -4559 403 -4560 402 -4561 403 -4562 403 -4563 402 -4564 403 -4565 403 -4566 402 -4567 403 -4568 403 -4569 402 -4570 403 -4571 403 -4572 402 -4573 403 -4574 403 -4575 402 -4576 403 -4577 403 -4578 402 -4579 403 -4580 403 -4581 402 -4582 403 -4583 403 -4584 402 -4585 403 -4586 403 -4587 402 -4588 403 -4589 403 -4590 402 -4591 403 -4592 403 -4593 402 -4594 403 -4595 403 -4596 402 -4597 403 -4598 403 -4599 402 -4600 403 -4601 403 -4602 402 -4603 403 -4604 403 -4605 402 -4606 403 -4607 403 -4608 402 -4609 403 -4610 403 -4611 402 -4612 403 -4613 403 -4614 402 -4615 403 -4616 403 -4617 402 -4618 403 -4619 403 -4620 402 -4621 403 -4622 403 -4623 402 -4624 403 -4625 403 -4626 402 -4627 403 -4628 403 -4629 402 -4630 403 -4631 403 -4632 402 -4633 403 -4634 403 -4635 402 -4636 403 -4637 403 -4638 402 -4639 403 -4640 403 -4641 402 -4642 403 -4643 403 -4644 402 -4645 403 -4646 403 -4647 402 -4648 403 -4649 403 -4650 402 -4651 403 -4652 403 -4653 402 -4654 403 -4655 403 -4656 402 -4657 403 -4658 403 -4659 402 -4660 403 -4661 403 -4662 402 -4663 403 -4664 403 -4665 402 -4666 403 -4667 403 -4668 402 -4669 403 -4670 403 -4671 402 -4672 403 -4673 403 -4674 402 -4675 403 -4676 403 -4677 402 -4678 403 -4679 403 -4680 402 -4681 403 -4682 403 -4683 402 -4684 403 -4685 403 -4686 402 -4687 403 -4688 403 -4689 402 -4690 403 -4691 403 -4692 402 -4693 403 -4694 403 -4695 402 -4696 403 -4697 403 -4698 402 -4699 403 -4700 403 -4701 402 -4702 403 -4703 403 -4704 402 -4705 403 -4706 403 -4707 402 -4708 403 -4709 403 -4710 402 -4711 403 -4712 403 -4713 402 -4714 403 -4715 403 -4716 402 -4717 403 -4718 403 -4719 402 -4720 403 -4721 403 -4722 402 -4723 403 -4724 403 -4725 402 -4726 403 -4727 403 -4728 402 -4729 403 -4730 403 -4731 402 -4732 403 -4733 403 -4734 402 -4735 403 -4736 403 -4737 402 -4738 403 -4739 403 -4740 402 -4741 403 -4742 403 -4743 402 -4744 403 -4745 403 -4746 402 -4747 403 -4748 403 -4749 402 -4750 403 -4751 403 -4752 402 -4753 403 -4754 403 -4755 402 -4756 403 -4757 403 -4758 402 -4759 403 -4760 403 -4761 402 -4762 403 -4763 403 -4764 402 -4765 403 -4766 403 -4767 402 -4768 403 -4769 403 -4770 402 -4771 403 -4772 403 -4773 402 -4774 403 -4775 403 -4776 402 -4777 403 -4778 403 -4779 402 -4780 403 -4781 403 -4782 402 -4783 403 -4784 403 -4785 402 -4786 403 -4787 403 -4788 402 -4789 403 -4790 403 -4791 402 -4792 403 -4793 403 -4794 402 -4795 403 -4796 403 -4797 402 -4798 403 -4799 403 -4800 402 -4801 403 -4802 403 -4803 402 -4804 403 -4805 403 -4806 402 -4807 403 -4808 403 -4809 402 -4810 403 -4811 403 -4812 402 -4813 403 -4814 403 -4815 402 -4816 403 -4817 403 -4818 402 -4819 403 -4820 403 -4821 402 -4822 403 -4823 403 -4824 402 -4825 403 -4826 403 -4827 402 -4828 403 -4829 403 -4830 402 -4831 403 -4832 403 -4833 402 -4834 403 -4835 403 -4836 402 -4837 403 -4838 403 -4839 402 -4840 403 -4841 403 -4842 402 -4843 403 -4844 403 -4845 402 -4846 403 -4847 403 -4848 402 -4849 403 -4850 403 -4851 402 -4852 403 -4853 403 -4854 402 -4855 403 -4856 403 -4857 402 -4858 403 -4859 403 -4860 402 -4861 403 -4862 403 -4863 402 -4864 403 -4865 403 -4866 402 -4867 403 -4868 403 -4869 402 -4870 403 -4871 403 -4872 402 -4873 403 -4874 403 -4875 402 -4876 403 -4877 403 -4878 402 -4879 403 -4880 403 -4881 402 -4882 403 -4883 403 -4884 402 -4885 403 -4886 403 -4887 402 -4888 403 -4889 403 -4890 402 -4891 403 -4892 403 -4893 402 -4894 403 -4895 403 -4896 402 -4897 403 -4898 403 -4899 402 -4900 403 -4901 403 -4902 402 -4903 403 -4904 403 -4905 402 -4906 403 -4907 403 -4908 402 -4909 403 -4910 403 -4911 402 -4912 403 -4913 403 -4914 402 -4915 403 -4916 403 -4917 402 -4918 403 -4919 403 -4920 402 -4921 403 -4922 403 -4923 402 -4924 403 -4925 403 -4926 402 -4927 403 -4928 403 -4929 402 -4930 403 -4931 403 -4932 402 -4933 403 -4934 403 -4935 402 -4936 403 -4937 403 -4938 402 -4939 403 -4940 403 -4941 402 -4942 403 -4943 403 -4944 402 -4945 403 -4946 403 -4947 402 -4948 403 -4949 403 -4950 402 -4951 403 -4952 403 -4953 402 -4954 403 -4955 403 -4956 402 -4957 403 -4958 403 -4959 402 -4960 403 -4961 403 -4962 402 -4963 403 -4964 403 -4965 402 -4966 403 -4967 403 -4968 402 -4969 403 -4970 403 -4971 402 -4972 403 -4973 403 -4974 402 -4975 403 -4976 403 -4977 402 -4978 403 -4979 403 -4980 402 -4981 403 -4982 403 -4983 402 -4984 403 -4985 403 -4986 402 -4987 403 -4988 403 -4989 402 -4990 403 -4991 403 -4992 402 -4993 403 -4994 403 -4995 402 -4996 403 -4997 403 -4998 402 -4999 403 -5000 403 -5001 402 -5002 403 -5003 403 -5004 402 -5005 403 -5006 403 -5007 402 -5008 403 -5009 403 -5010 402 -5011 403 -5012 403 -5013 402 -5014 403 -5015 403 -5016 402 -5017 403 -5018 403 -5019 402 -5020 403 -5021 403 -5022 402 -5023 403 -5024 403 -5025 402 -5026 403 -5027 403 -5028 402 -5029 403 -5030 403 -5031 402 -5032 403 -5033 403 -5034 402 -5035 403 -5036 403 -5037 402 -5038 403 -5039 403 -5040 402 -5041 403 -5042 403 -5043 402 -5044 403 -5045 403 -5046 402 -5047 403 -5048 403 -5049 402 -5050 403 -5051 403 -5052 402 -5053 403 -5054 403 -5055 402 -5056 403 -5057 403 -5058 402 -5059 403 -5060 403 -5061 402 -5062 403 -5063 403 -5064 402 -5065 403 -5066 403 -5067 402 -5068 403 -5069 403 -5070 402 -5071 403 -5072 403 -5073 402 -5074 403 -5075 403 -5076 402 -5077 403 -5078 403 -5079 402 -5080 403 -5081 403 -5082 402 -5083 403 -5084 403 -5085 402 -5086 403 -5087 403 -5088 402 -5089 403 -5090 403 -5091 402 -5092 403 -5093 403 -5094 402 -5095 403 -5096 403 -5097 402 -5098 403 -5099 403 -5100 402 -5101 403 -5102 403 -5103 402 -5104 403 -5105 403 -5106 402 -5107 403 -5108 403 -5109 402 -5110 403 -5111 403 -5112 402 -5113 403 -5114 403 -5115 402 -5116 403 -5117 403 -5118 402 -5119 403 -5120 403 -5121 402 -5122 403 -5123 403 -5124 402 -5125 403 -5126 403 -5127 402 -5128 403 -5129 403 -5130 402 -5131 403 -5132 403 -5133 402 -5134 403 -5135 403 -5136 402 -5137 403 -5138 403 -5139 402 -5140 403 -5141 403 -5142 402 -5143 403 -5144 403 -5145 402 -5146 403 -5147 403 -5148 402 -5149 403 -5150 403 -5151 402 -5152 403 -5153 403 -5154 402 -5155 403 -5156 403 -5157 402 -5158 403 -5159 403 -5160 402 -5161 403 -5162 403 -5163 402 -5164 403 -5165 403 -5166 402 -5167 403 -5168 403 -5169 402 -5170 403 -5171 403 -5172 402 -5173 403 -5174 403 -5175 402 -5176 403 -5177 403 -5178 402 -5179 403 -5180 403 -5181 402 -5182 403 -5183 403 -5184 402 -5185 403 -5186 403 -5187 402 -5188 403 -5189 403 -5190 402 -5191 403 -5192 403 -5193 402 -5194 403 -5195 403 -5196 402 -5197 403 -5198 403 -5199 402 -5200 403 -5201 403 -5202 402 -5203 403 -5204 403 -5205 402 -5206 403 -5207 403 -5208 402 -5209 403 -5210 403 -5211 402 -5212 403 -5213 403 -5214 402 -5215 403 -5216 403 -5217 402 -5218 403 -5219 403 -5220 402 -5221 403 -5222 403 -5223 402 -5224 403 -5225 403 -5226 402 -5227 403 -5228 403 -5229 402 -5230 403 -5231 403 -5232 402 -5233 403 -5234 403 -5235 402 -5236 403 -5237 403 -5238 402 -5239 403 -5240 403 -5241 402 -5242 403 -5243 403 -5244 402 -5245 403 -5246 403 -5247 402 -5248 403 -5249 403 -5250 402 -5251 403 -5252 403 -5253 402 -5254 403 -5255 403 -5256 402 -5257 403 -5258 403 -5259 402 -5260 403 -5261 403 -5262 402 -5263 403 -5264 403 -5265 402 -5266 403 -5267 403 -5268 402 -5269 403 -5270 403 -5271 402 -5272 403 -5273 403 -5274 402 -5275 403 -5276 403 -5277 402 -5278 403 -5279 403 -5280 402 -5281 403 -5282 403 -5283 402 -5284 403 -5285 403 -5286 402 -5287 403 -5288 403 -5289 402 -5290 403 -5291 403 -5292 402 -5293 403 -5294 403 -5295 402 -5296 403 -5297 403 -5298 402 -5299 403 -5300 403 -5301 402 -5302 403 -5303 403 -5304 402 -5305 403 -5306 403 -5307 402 -5308 403 -5309 403 -5310 402 -5311 403 -5312 403 -5313 402 -5314 403 -5315 403 -5316 402 -5317 403 -5318 403 -5319 402 -5320 403 -5321 403 -5322 402 -5323 403 -5324 403 -5325 402 -5326 403 -5327 403 -5328 402 -5329 403 -5330 403 -5331 402 -5332 403 -5333 403 -5334 402 -5335 403 -5336 403 -5337 402 -5338 403 -5339 403 -5340 402 -5341 403 -5342 403 -5343 402 -5344 403 -5345 403 -5346 402 -5347 403 -5348 403 -5349 402 -5350 403 -5351 403 -5352 402 -5353 403 -5354 403 -5355 402 -5356 403 -5357 403 -5358 402 -5359 403 -5360 403 -5361 402 -5362 403 -5363 403 -5364 402 -5365 403 -5366 403 -5367 402 -5368 403 -5369 403 -5370 402 -5371 403 -5372 403 -5373 402 -5374 403 -5375 403 -5376 402 -5377 403 -5378 403 -5379 402 -5380 403 -5381 403 -5382 402 -5383 403 -5384 403 -5385 402 -5386 403 -5387 403 -5388 402 -5389 403 -5390 403 -5391 402 -5392 403 -5393 403 -5394 402 -5395 403 -5396 403 -5397 402 -5398 403 -5399 403 -5400 402 -5401 403 -5402 403 -5403 402 -5404 403 -5405 403 -5406 402 -5407 403 -5408 403 -5409 402 -5410 403 -5411 403 -5412 402 -5413 403 -5414 403 -5415 402 -5416 403 -5417 403 -5418 402 -5419 403 -5420 403 -5421 402 -5422 403 -5423 403 -5424 402 -5425 403 -5426 403 -5427 402 -5428 403 -5429 403 -5430 402 -5431 403 -5432 403 -5433 402 -5434 403 -5435 403 -5436 402 -5437 403 -5438 403 -5439 402 -5440 403 -5441 403 -5442 402 -5443 403 -5444 403 -5445 402 -5446 403 -5447 403 -5448 402 -5449 403 -5450 403 -5451 402 -5452 403 -5453 403 -5454 402 -5455 403 -5456 403 -5457 402 -5458 403 -5459 403 -5460 402 -5461 403 -5462 403 -5463 402 -5464 403 -5465 403 -5466 402 -5467 403 -5468 403 -5469 402 -5470 403 -5471 403 -5472 402 -5473 403 -5474 403 -5475 402 -5476 403 -5477 403 -5478 402 -5479 403 -5480 403 -5481 402 -5482 403 -5483 403 -5484 402 -5485 403 -5486 403 -5487 402 -5488 403 -5489 403 -5490 402 -5491 403 -5492 403 -5493 402 -5494 403 -5495 403 -5496 402 -5497 403 -5498 403 -5499 402 -5500 403 -5501 403 -5502 402 -5503 403 -5504 403 -5505 402 -5506 403 -5507 403 -5508 402 -5509 403 -5510 403 -5511 402 -5512 403 -5513 403 -5514 402 -5515 403 -5516 403 -5517 402 -5518 403 -5519 403 -5520 402 -5521 403 -5522 403 -5523 402 -5524 403 -5525 403 -5526 402 -5527 403 -5528 403 -5529 402 -5530 403 -5531 403 -5532 402 -5533 403 -5534 403 -5535 402 -5536 403 -5537 403 -5538 402 -5539 403 -5540 403 -5541 402 -5542 403 -5543 403 -5544 402 -5545 403 -5546 403 -5547 402 -5548 403 -5549 403 -5550 402 -5551 403 -5552 403 -5553 402 -5554 403 -5555 403 -5556 402 -5557 403 -5558 403 -5559 402 -5560 403 -5561 403 -5562 402 -5563 403 -5564 403 -5565 402 -5566 403 -5567 403 -5568 402 -5569 403 -5570 403 -5571 402 -5572 403 -5573 403 -5574 402 -5575 403 -5576 403 -5577 402 -5578 403 -5579 403 -5580 402 -5581 403 -5582 403 -5583 402 -5584 403 -5585 403 -5586 402 -5587 403 -5588 403 -5589 402 -5590 403 -5591 403 -5592 402 -5593 403 -5594 403 -5595 402 -5596 403 -5597 403 -5598 402 -5599 403 -5600 403 -5601 402 -5602 403 -5603 403 -5604 402 -5605 403 -5606 403 -5607 402 -5608 403 -5609 403 -5610 402 -5611 403 -5612 403 -5613 402 -5614 403 -5615 403 -5616 402 -5617 403 -5618 403 -5619 402 -5620 403 -5621 403 -5622 402 -5623 403 -5624 403 -5625 402 -5626 403 -5627 403 -5628 402 -5629 403 -5630 403 -5631 402 -5632 403 -5633 403 -5634 402 -5635 403 -5636 403 -5637 402 -5638 403 -5639 403 -5640 402 -5641 403 -5642 403 -5643 402 -5644 403 -5645 403 -5646 402 -5647 403 -5648 403 -5649 402 -5650 403 -5651 403 -5652 402 -5653 403 -5654 403 -5655 402 -5656 403 -5657 403 -5658 402 -5659 403 -5660 403 -5661 402 -5662 403 -5663 403 -5664 402 -5665 403 -5666 403 -5667 402 -5668 403 -5669 403 -5670 402 -5671 403 -5672 403 -5673 402 -5674 403 -5675 403 -5676 402 -5677 403 -5678 403 -5679 402 -5680 403 -5681 403 -5682 402 -5683 403 -5684 403 -5685 402 -5686 403 -5687 403 -5688 402 -5689 403 -5690 403 -5691 402 -5692 403 -5693 403 -5694 402 -5695 403 -5696 403 -5697 402 -5698 403 -5699 403 -5700 402 -5701 403 -5702 403 -5703 402 -5704 403 -5705 403 -5706 402 -5707 403 -5708 403 -5709 402 -5710 403 -5711 403 -5712 402 -5713 403 -5714 403 -5715 402 -5716 403 -5717 403 -5718 402 -5719 403 -5720 403 -5721 402 -5722 403 -5723 403 -5724 402 -5725 403 -5726 403 -5727 402 -5728 403 -5729 403 -5730 402 -5731 403 -5732 403 -5733 402 -5734 403 -5735 403 -5736 402 -5737 403 -5738 403 -5739 402 -5740 403 -5741 403 -5742 402 -5743 403 -5744 403 -5745 402 -5746 403 -5747 403 -5748 402 -5749 403 -5750 403 -5751 402 -5752 403 -5753 403 -5754 402 -5755 403 -5756 403 -5757 402 -5758 403 -5759 403 -5760 402 -5761 403 -5762 403 -5763 402 -5764 403 -5765 403 -5766 402 -5767 403 -5768 403 -5769 402 -5770 403 -5771 403 -5772 402 -5773 403 -5774 403 -5775 402 -5776 403 -5777 403 -5778 402 -5779 403 -5780 403 -5781 402 -5782 403 -5783 403 -5784 402 -5785 403 -5786 403 -5787 402 -5788 403 -5789 403 -5790 402 -5791 403 -5792 403 -5793 402 -5794 403 -5795 403 -5796 402 -5797 403 -5798 403 -5799 402 -5800 403 -5801 403 -5802 402 -5803 403 -5804 403 -5805 402 -5806 403 -5807 403 -5808 402 -5809 403 -5810 403 -5811 402 -5812 403 -5813 403 -5814 402 -5815 403 -5816 403 -5817 402 -5818 403 -5819 403 -5820 402 -5821 403 -5822 403 -5823 402 -5824 403 -5825 403 -5826 402 -5827 403 -5828 403 -5829 402 -5830 403 -5831 403 -5832 402 -5833 403 -5834 403 -5835 402 -5836 403 -5837 403 -5838 402 -5839 403 -5840 403 -5841 402 -5842 403 -5843 403 -5844 402 -5845 403 -5846 403 -5847 402 -5848 403 -5849 403 -5850 402 -5851 403 -5852 403 -5853 402 -5854 403 -5855 403 -5856 402 -5857 403 -5858 403 -5859 402 -5860 403 -5861 403 -5862 402 -5863 403 -5864 403 -5865 402 -5866 403 -5867 403 -5868 402 -5869 403 -5870 403 -5871 402 -5872 403 -5873 403 -5874 402 -5875 403 -5876 403 -5877 402 -5878 403 -5879 403 -5880 402 -5881 403 -5882 403 -5883 402 -5884 403 -5885 403 -5886 402 -5887 403 -5888 403 -5889 402 -5890 403 -5891 403 -5892 402 -5893 403 -5894 403 -5895 402 -5896 403 -5897 403 -5898 402 -5899 403 -5900 403 -5901 402 -5902 403 -5903 403 -5904 402 -5905 403 -5906 403 -5907 402 -5908 403 -5909 403 -5910 402 -5911 403 -5912 403 -5913 402 -5914 403 -5915 403 -5916 402 -5917 403 -5918 403 -5919 402 -5920 403 -5921 403 -5922 402 -5923 403 -5924 403 -5925 402 -5926 403 -5927 403 -5928 402 -5929 403 -5930 403 -5931 402 -5932 403 -5933 403 -5934 402 -5935 403 -5936 403 -5937 402 -5938 403 -5939 403 -5940 402 -5941 403 -5942 403 -5943 402 -5944 403 -5945 403 -5946 402 -5947 403 -5948 403 -5949 402 -5950 403 -5951 403 -5952 402 -5953 403 -5954 403 -5955 402 -5956 403 -5957 403 -5958 402 -5959 403 -5960 403 -5961 402 -5962 403 -5963 403 -5964 402 -5965 403 -5966 403 -5967 402 -5968 403 -5969 403 -5970 402 -5971 403 -5972 403 -5973 402 -5974 403 -5975 403 -5976 402 -5977 403 -5978 403 -5979 402 -5980 403 -5981 403 -5982 402 -5983 403 -5984 403 -5985 402 -5986 403 -5987 403 -5988 402 -5989 403 -5990 403 -5991 402 -5992 403 -5993 403 -5994 402 -5995 403 -5996 403 -5997 402 -5998 403 -5999 403 -6000 402 -6001 403 -6002 403 -6003 402 -6004 403 -6005 403 -6006 402 -6007 403 -6008 403 -6009 402 -6010 403 -6011 403 -6012 402 -6013 403 -6014 403 -6015 402 -6016 403 -6017 403 -6018 402 -6019 403 -6020 403 -6021 402 -6022 403 -6023 403 -6024 402 -6025 403 -6026 403 -6027 402 -6028 403 -6029 403 -6030 402 -6031 403 -6032 403 -6033 402 -6034 403 -6035 403 -6036 402 -6037 403 -6038 403 -6039 402 -6040 403 -6041 403 -6042 402 -6043 403 -6044 403 -6045 402 -6046 403 -6047 403 -6048 402 -6049 403 -6050 403 -6051 402 -6052 403 -6053 403 -6054 402 -6055 403 -6056 403 -6057 402 -6058 403 -6059 403 -6060 402 -6061 403 -6062 403 -6063 402 -6064 403 -6065 403 -6066 402 -6067 403 -6068 403 -6069 402 -6070 403 -6071 403 -6072 402 -6073 403 -6074 403 -6075 402 -6076 403 -6077 403 -6078 402 -6079 403 -6080 403 -6081 402 -6082 403 -6083 403 -6084 402 -6085 403 -6086 403 -6087 402 -6088 403 -6089 403 -6090 402 -6091 403 -6092 403 -6093 402 -6094 403 -6095 403 -6096 402 -6097 403 -6098 403 -6099 402 -6100 403 -6101 403 -6102 402 -6103 403 -6104 403 -6105 402 -6106 403 -6107 403 -6108 402 -6109 403 -6110 403 -6111 402 -6112 403 -6113 403 -6114 402 -6115 403 -6116 403 -6117 402 -6118 403 -6119 403 -6120 402 -6121 403 -6122 403 -6123 402 -6124 403 -6125 403 -6126 402 -6127 403 -6128 403 -6129 402 -6130 403 -6131 403 -6132 402 -6133 403 -6134 403 -6135 402 -6136 403 -6137 403 -6138 402 -6139 403 -6140 403 -6141 402 -6142 403 -6143 403 -6144 402 -6145 403 -6146 403 -6147 402 -6148 403 -6149 403 -6150 402 -6151 403 -6152 403 -6153 402 -6154 403 -6155 403 -6156 402 -6157 403 -6158 403 -6159 402 -6160 403 -6161 403 -6162 402 -6163 403 -6164 403 -6165 402 -6166 403 -6167 403 -6168 402 -6169 403 -6170 403 -6171 402 -6172 403 -6173 403 -6174 402 -6175 403 -6176 403 -6177 402 -6178 403 -6179 403 -6180 402 -6181 403 -6182 403 -6183 402 -6184 403 -6185 403 -6186 402 -6187 403 -6188 403 -6189 402 -6190 403 -6191 403 -6192 402 -6193 403 -6194 403 -6195 402 -6196 403 -6197 403 -6198 402 -6199 403 -6200 403 -6201 402 -6202 403 -6203 403 -6204 402 -6205 403 -6206 403 -6207 402 -6208 403 -6209 403 -6210 402 -6211 403 -6212 403 -6213 402 -6214 403 -6215 403 -6216 402 -6217 403 -6218 403 -6219 402 -6220 403 -6221 403 -6222 402 -6223 403 -6224 403 -6225 402 -6226 403 -6227 403 -6228 402 -6229 403 -6230 403 -6231 402 -6232 403 -6233 403 -6234 402 -6235 403 -6236 403 -6237 402 -6238 403 -6239 403 -6240 402 -6241 403 -6242 403 -6243 402 -6244 403 -6245 403 -6246 402 -6247 403 -6248 403 -6249 402 -6250 403 -6251 403 -6252 402 -6253 403 -6254 403 -6255 402 -6256 403 -6257 403 -6258 402 -6259 403 -6260 403 -6261 402 -6262 403 -6263 403 -6264 402 -6265 403 -6266 403 -6267 402 -6268 403 -6269 403 -6270 402 -6271 403 -6272 403 -6273 402 -6274 403 -6275 403 -6276 402 -6277 403 -6278 403 -6279 402 -6280 403 -6281 403 -6282 402 -6283 403 -6284 403 -6285 402 -6286 403 -6287 403 -6288 402 -6289 403 -6290 403 -6291 402 -6292 403 -6293 403 -6294 402 -6295 403 -6296 403 -6297 402 -6298 403 -6299 403 -6300 402 -6301 403 -6302 403 -6303 402 -6304 403 -6305 403 -6306 402 -6307 403 -6308 403 -6309 402 -6310 403 -6311 403 -6312 402 -6313 403 -6314 403 -6315 402 -6316 403 -6317 403 -6318 402 -6319 403 -6320 403 -6321 402 -6322 403 -6323 403 -6324 402 -6325 403 -6326 403 -6327 402 -6328 403 -6329 403 -6330 402 -6331 403 -6332 403 -6333 402 -6334 403 -6335 403 -6336 402 -6337 403 -6338 403 -6339 402 -6340 403 -6341 403 -6342 402 -6343 403 -6344 403 -6345 402 -6346 403 -6347 403 -6348 402 -6349 403 -6350 403 -6351 402 -6352 403 -6353 403 -6354 402 -6355 403 -6356 403 -6357 402 -6358 403 -6359 403 -6360 402 -6361 403 -6362 403 -6363 402 -6364 403 -6365 403 -6366 402 -6367 403 -6368 403 -6369 402 -6370 403 -6371 403 -6372 402 -6373 403 -6374 403 -6375 402 -6376 403 -6377 403 -6378 402 -6379 403 -6380 403 -6381 402 -6382 403 -6383 403 -6384 402 -6385 403 -6386 403 -6387 402 -6388 403 -6389 403 -6390 402 -6391 403 -6392 403 -6393 402 -6394 403 -6395 403 -6396 402 -6397 403 -6398 403 -6399 402 -6400 403 -6401 403 -6402 402 -6403 403 -6404 403 -6405 402 -6406 403 -6407 403 -6408 402 -6409 403 -6410 403 -6411 402 -6412 403 -6413 403 -6414 402 -6415 403 -6416 403 -6417 402 -6418 403 -6419 403 -6420 402 -6421 403 -6422 403 -6423 402 -6424 403 -6425 403 -6426 402 -6427 403 -6428 403 -6429 402 -6430 403 -6431 403 -6432 402 -6433 403 -6434 403 -6435 402 -6436 403 -6437 403 -6438 402 -6439 403 -6440 403 -6441 402 -6442 403 -6443 403 -6444 402 -6445 403 -6446 403 -6447 402 -6448 403 -6449 403 -6450 402 -6451 403 -6452 403 -6453 402 -6454 403 -6455 403 -6456 402 -6457 403 -6458 403 -6459 402 -6460 403 -6461 403 -6462 402 -6463 403 -6464 403 -6465 402 -6466 403 -6467 403 -6468 402 -6469 403 -6470 403 -6471 402 -6472 403 -6473 403 -6474 402 -6475 403 -6476 403 -6477 402 -6478 403 -6479 403 -6480 402 -6481 403 -6482 403 -6483 402 -6484 403 -6485 403 -6486 402 -6487 403 -6488 403 -6489 402 -6490 403 -6491 403 -6492 402 -6493 403 -6494 403 -6495 402 -6496 403 -6497 403 -6498 402 -6499 403 -6500 403 -6501 402 -6502 403 -6503 403 -6504 402 -6505 403 -6506 403 -6507 402 -6508 403 -6509 403 -6510 402 -6511 403 -6512 403 -6513 402 -6514 403 -6515 403 -6516 402 -6517 403 -6518 403 -6519 402 -6520 403 -6521 403 -6522 402 -6523 403 -6524 403 -6525 402 -6526 403 -6527 403 -6528 402 -6529 403 -6530 403 -6531 402 -6532 403 -6533 403 -6534 402 -6535 403 -6536 403 -6537 402 -6538 403 -6539 403 -6540 402 -6541 403 -6542 403 -6543 402 -6544 403 -6545 403 -6546 402 -6547 403 -6548 403 -6549 402 -6550 403 -6551 403 -6552 402 -6553 403 -6554 403 -6555 402 -6556 403 -6557 403 -6558 402 -6559 403 -6560 403 -6561 402 -6562 403 -6563 403 -6564 402 -6565 403 -6566 403 -6567 402 -6568 403 -6569 403 -6570 402 -6571 403 -6572 403 -6573 402 -6574 403 -6575 403 -6576 402 -6577 403 -6578 403 -6579 402 -6580 403 -6581 403 -6582 402 -6583 403 -6584 403 -6585 402 -6586 403 -6587 403 -6588 402 -6589 403 -6590 403 -6591 402 -6592 403 -6593 403 -6594 402 -6595 403 -6596 403 -6597 402 -6598 403 -6599 403 -6600 402 -6601 403 -6602 403 -6603 402 -6604 403 -6605 403 -6606 402 -6607 403 -6608 403 -6609 402 -6610 403 -6611 403 -6612 402 -6613 403 -6614 403 -6615 402 -6616 403 -6617 403 -6618 402 -6619 403 -6620 403 -6621 402 -6622 403 -6623 403 -6624 402 -6625 403 -6626 403 -6627 402 -6628 403 -6629 403 -6630 402 -6631 403 -6632 403 -6633 402 -6634 403 -6635 403 -6636 402 -6637 403 -6638 403 -6639 402 -6640 403 -6641 403 -6642 402 -6643 403 -6644 403 -6645 402 -6646 403 -6647 403 -6648 402 -6649 403 -6650 403 -6651 402 -6652 403 -6653 403 -6654 402 -6655 403 -6656 403 -6657 402 -6658 403 -6659 403 -6660 402 -6661 403 -6662 403 -6663 402 -6664 403 -6665 403 -6666 402 -6667 403 -6668 403 -6669 402 -6670 403 -6671 403 -6672 402 -6673 403 -6674 403 -6675 402 -6676 403 -6677 403 -6678 402 -6679 403 -6680 403 -6681 402 -6682 403 -6683 403 -6684 402 -6685 403 -6686 403 -6687 402 -6688 403 -6689 403 -6690 402 -6691 403 -6692 403 -6693 402 -6694 403 -6695 403 -6696 402 -6697 403 -6698 403 -6699 402 -6700 403 -6701 403 -6702 402 -6703 403 -6704 403 -6705 402 -6706 403 -6707 403 -6708 402 -6709 403 -6710 403 -6711 402 -6712 403 -6713 403 -6714 402 -6715 403 -6716 403 -6717 402 -6718 403 -6719 403 -6720 402 -6721 403 -6722 403 -6723 402 -6724 403 -6725 403 -6726 402 -6727 403 -6728 403 -6729 402 -6730 403 -6731 403 -6732 402 -6733 403 -6734 403 -6735 402 -6736 403 -6737 403 -6738 402 -6739 403 -6740 403 -6741 402 -6742 403 -6743 403 -6744 402 -6745 403 -6746 403 -6747 402 -6748 403 -6749 403 -6750 402 -6751 403 -6752 403 -6753 402 -6754 403 -6755 403 -6756 402 -6757 403 -6758 403 -6759 402 -6760 403 -6761 403 -6762 402 -6763 403 -6764 403 -6765 402 -6766 403 -6767 403 -6768 402 -6769 403 -6770 403 -6771 402 -6772 403 -6773 403 -6774 402 -6775 403 -6776 403 -6777 402 -6778 403 -6779 403 -6780 402 -6781 403 -6782 403 -6783 402 -6784 403 -6785 403 -6786 402 -6787 403 -6788 403 -6789 402 -6790 403 -6791 403 -6792 402 -6793 403 -6794 403 -6795 402 -6796 403 -6797 403 -6798 402 -6799 403 -6800 403 -6801 402 -6802 403 -6803 403 -6804 402 -6805 403 -6806 403 -6807 402 -6808 403 -6809 403 -6810 402 -6811 403 -6812 403 -6813 402 -6814 403 -6815 403 -6816 402 -6817 403 -6818 403 -6819 402 -6820 403 -6821 403 -6822 402 -6823 403 -6824 403 -6825 402 -6826 403 -6827 403 -6828 402 -6829 403 -6830 403 -6831 402 -6832 403 -6833 403 -6834 402 -6835 403 -6836 403 -6837 402 -6838 403 -6839 403 -6840 402 -6841 403 -6842 403 -6843 402 -6844 403 -6845 403 -6846 402 -6847 403 -6848 403 -6849 402 -6850 403 -6851 403 -6852 402 -6853 403 -6854 403 -6855 402 -6856 403 -6857 403 -6858 402 -6859 403 -6860 403 -6861 402 -6862 403 -6863 403 -6864 402 -6865 403 -6866 403 -6867 402 -6868 403 -6869 403 -6870 402 -6871 403 -6872 403 -6873 402 -6874 403 -6875 403 -6876 402 -6877 403 -6878 403 -6879 402 -6880 403 -6881 403 -6882 402 -6883 403 -6884 403 -6885 402 -6886 403 -6887 403 -6888 402 -6889 403 -6890 403 -6891 402 -6892 403 -6893 403 -6894 402 -6895 403 -6896 403 -6897 402 -6898 403 -6899 403 -6900 402 -6901 403 -6902 403 -6903 402 -6904 403 -6905 403 -6906 402 -6907 403 -6908 403 -6909 402 -6910 403 -6911 403 -6912 402 -6913 403 -6914 403 -6915 402 -6916 403 -6917 403 -6918 402 -6919 403 -6920 403 -6921 402 -6922 403 -6923 403 -6924 402 -6925 403 -6926 403 -6927 402 -6928 403 -6929 403 -6930 402 -6931 403 -6932 403 -6933 402 -6934 403 -6935 403 -6936 402 -6937 403 -6938 403 -6939 402 -6940 403 -6941 403 -6942 402 -6943 403 -6944 403 -6945 402 -6946 403 -6947 403 -6948 402 -6949 403 -6950 403 -6951 402 -6952 403 -6953 403 -6954 402 -6955 403 -6956 403 -6957 402 -6958 403 -6959 403 -6960 402 -6961 403 -6962 403 -6963 402 -6964 403 -6965 403 -6966 402 -6967 403 -6968 403 -6969 402 -6970 403 -6971 403 -6972 402 -6973 403 -6974 403 -6975 402 -6976 403 -6977 403 -6978 402 -6979 403 -6980 403 -6981 402 -6982 403 -6983 403 -6984 402 -6985 403 -6986 403 -6987 402 -6988 403 -6989 403 -6990 402 -6991 403 -6992 403 -6993 402 -6994 403 -6995 403 -6996 402 -6997 403 -6998 403 -6999 402 -7000 403 -7001 403 -7002 402 -7003 403 -7004 403 -7005 402 -7006 403 -7007 403 -7008 402 -7009 403 -7010 403 -7011 402 -7012 403 -7013 403 -7014 402 -7015 403 -7016 403 -7017 402 -7018 403 -7019 403 -7020 402 -7021 403 -7022 403 -7023 402 -7024 403 -7025 403 -7026 402 -7027 403 -7028 403 -7029 402 -7030 403 -7031 403 -7032 402 -7033 403 -7034 403 -7035 402 -7036 403 -7037 403 -7038 402 -7039 403 -7040 403 -7041 402 -7042 403 -7043 403 -7044 402 -7045 403 -7046 403 -7047 402 -7048 403 -7049 403 -7050 402 -7051 403 -7052 403 -7053 402 -7054 403 -7055 403 -7056 402 -7057 403 -7058 403 -7059 402 -7060 403 -7061 403 -7062 402 -7063 403 -7064 403 -7065 402 -7066 403 -7067 403 -7068 402 -7069 403 -7070 403 -7071 402 -7072 403 -7073 403 -7074 402 -7075 403 -7076 403 -7077 402 -7078 403 -7079 403 -7080 402 -7081 403 -7082 403 -7083 402 -7084 403 -7085 403 -7086 402 -7087 403 -7088 403 -7089 402 -7090 403 -7091 403 -7092 402 -7093 403 -7094 403 -7095 402 -7096 403 -7097 403 -7098 402 -7099 403 -7100 403 -7101 402 -7102 403 -7103 403 -7104 402 -7105 403 -7106 403 -7107 402 -7108 403 -7109 403 -7110 402 -7111 403 -7112 403 -7113 402 -7114 403 -7115 403 -7116 402 -7117 403 -7118 403 -7119 402 -7120 403 -7121 403 -7122 402 -7123 403 -7124 403 -7125 402 -7126 403 -7127 403 -7128 402 -7129 403 -7130 403 -7131 402 -7132 403 -7133 403 -7134 402 -7135 403 -7136 403 -7137 402 -7138 403 -7139 403 -7140 402 -7141 403 -7142 403 -7143 402 -7144 403 -7145 403 -7146 402 -7147 403 -7148 403 -7149 402 -7150 403 -7151 403 -7152 402 -7153 403 -7154 403 -7155 402 -7156 403 -7157 403 -7158 402 -7159 403 -7160 403 -7161 402 -7162 403 -7163 403 -7164 402 -7165 403 -7166 403 -7167 402 -7168 403 -7169 403 -7170 402 -7171 403 -7172 403 -7173 402 -7174 403 -7175 403 -7176 402 -7177 403 -7178 403 -7179 402 -7180 403 -7181 403 -7182 402 -7183 403 -7184 403 -7185 402 -7186 403 -7187 403 -7188 402 -7189 403 -7190 403 -7191 402 -7192 403 -7193 403 -7194 402 -7195 403 -7196 403 -7197 402 -7198 403 -7199 403 -7200 402 -7201 403 -7202 403 -7203 402 -7204 403 -7205 403 -7206 402 -7207 403 -7208 403 -7209 402 -7210 403 -7211 403 -7212 402 -7213 403 -7214 403 -7215 402 -7216 403 -7217 403 -7218 402 -7219 403 -7220 403 -7221 402 -7222 403 -7223 403 -7224 402 -7225 403 -7226 403 -7227 402 -7228 403 -7229 403 -7230 402 -7231 403 -7232 403 -7233 402 -7234 403 -7235 403 -7236 402 -7237 403 -7238 403 -7239 402 -7240 403 -7241 403 -7242 402 -7243 403 -7244 403 -7245 402 -7246 403 -7247 403 -7248 402 -7249 403 -7250 403 -7251 402 -7252 403 -7253 403 -7254 402 -7255 403 -7256 403 -7257 402 -7258 403 -7259 403 -7260 402 -7261 403 -7262 403 -7263 402 -7264 403 -7265 403 -7266 402 -7267 403 -7268 403 -7269 402 -7270 403 -7271 403 -7272 402 -7273 403 -7274 403 -7275 402 -7276 403 -7277 403 -7278 402 -7279 403 -7280 403 -7281 402 -7282 403 -7283 403 -7284 402 -7285 403 -7286 403 -7287 402 -7288 403 -7289 403 -7290 402 -7291 403 -7292 403 -7293 402 -7294 403 -7295 403 -7296 402 -7297 403 -7298 403 -7299 402 -7300 403 -7301 403 -7302 402 -7303 403 -7304 403 -7305 402 -7306 403 -7307 403 -7308 402 -7309 403 -7310 403 -7311 402 -7312 403 -7313 403 -7314 402 -7315 403 -7316 403 -7317 402 -7318 403 -7319 403 -7320 402 -7321 403 -7322 403 -7323 402 -7324 403 -7325 403 -7326 402 -7327 403 -7328 403 -7329 402 -7330 403 -7331 403 -7332 402 -7333 403 -7334 403 -7335 402 -7336 403 -7337 403 -7338 402 -7339 403 -7340 403 -7341 402 -7342 403 -7343 403 -7344 402 -7345 403 -7346 403 -7347 402 -7348 403 -7349 403 -7350 402 -7351 403 -7352 403 -7353 402 -7354 403 -7355 403 -7356 402 -7357 403 -7358 403 -7359 402 -7360 403 -7361 403 -7362 402 -7363 403 -7364 403 -7365 402 -7366 403 -7367 403 -7368 402 -7369 403 -7370 403 -7371 402 -7372 403 -7373 403 -7374 402 -7375 403 -7376 403 -7377 402 -7378 403 -7379 403 -7380 402 -7381 403 -7382 403 -7383 402 -7384 403 -7385 403 -7386 402 -7387 403 -7388 403 -7389 402 -7390 403 -7391 403 -7392 402 -7393 403 -7394 403 -7395 402 -7396 403 -7397 403 -7398 402 -7399 403 -7400 403 -7401 402 -7402 403 -7403 403 -7404 402 -7405 403 -7406 403 -7407 402 -7408 403 -7409 403 -7410 402 -7411 403 -7412 403 -7413 402 -7414 403 -7415 403 -7416 402 -7417 403 -7418 403 -7419 402 -7420 403 -7421 403 -7422 402 -7423 403 -7424 403 -7425 402 -7426 403 -7427 403 -7428 402 -7429 403 -7430 403 -7431 402 -7432 403 -7433 403 -7434 402 -7435 403 -7436 403 -7437 402 -7438 403 -7439 403 -7440 402 -7441 403 -7442 403 -7443 402 -7444 403 -7445 403 -7446 402 -7447 403 -7448 403 -7449 402 -7450 403 -7451 403 -7452 402 -7453 403 -7454 403 -7455 402 -7456 403 -7457 403 -7458 402 -7459 403 -7460 403 -7461 402 -7462 403 -7463 403 -7464 402 -7465 403 -7466 403 -7467 402 -7468 403 -7469 403 -7470 402 -7471 403 -7472 403 -7473 402 -7474 403 -7475 403 -7476 402 -7477 403 -7478 403 -7479 402 -7480 403 -7481 403 -7482 402 -7483 403 -7484 403 -7485 402 -7486 403 -7487 403 -7488 402 -7489 403 -7490 403 -7491 402 -7492 403 -7493 403 -7494 402 -7495 403 -7496 403 -7497 402 -7498 403 -7499 403 -7500 402 -7501 403 -7502 403 -7503 402 -7504 403 -7505 403 -7506 402 -7507 403 -7508 403 -7509 402 -7510 403 -7511 403 -7512 402 -7513 403 -7514 403 -7515 402 -7516 403 -7517 403 -7518 402 -7519 403 -7520 403 -7521 402 -7522 403 -7523 403 -7524 402 -7525 403 -7526 403 -7527 402 -7528 403 -7529 403 -7530 402 -7531 403 -7532 403 -7533 402 -7534 403 -7535 403 -7536 402 -7537 403 -7538 403 -7539 402 -7540 403 -7541 403 -7542 402 -7543 403 -7544 403 -7545 402 -7546 403 -7547 403 -7548 402 -7549 403 -7550 403 -7551 402 -7552 403 -7553 403 -7554 402 -7555 403 -7556 403 -7557 402 -7558 403 -7559 403 -7560 402 -7561 403 -7562 403 -7563 402 -7564 403 -7565 403 -7566 402 -7567 403 -7568 403 -7569 402 -7570 403 -7571 403 -7572 402 -7573 403 -7574 403 -7575 402 -7576 403 -7577 403 -7578 402 -7579 403 -7580 403 -7581 402 -7582 403 -7583 403 -7584 402 -7585 403 -7586 403 -7587 402 -7588 403 -7589 403 -7590 402 -7591 403 -7592 403 -7593 402 -7594 403 -7595 403 -7596 402 -7597 403 -7598 403 -7599 402 -7600 403 -7601 403 -7602 402 -7603 403 -7604 403 -7605 402 -7606 403 -7607 403 -7608 402 -7609 403 -7610 403 -7611 402 -7612 403 -7613 403 -7614 402 -7615 403 -7616 403 -7617 402 -7618 403 -7619 403 -7620 402 -7621 403 -7622 403 -7623 402 -7624 403 -7625 403 -7626 402 -7627 403 -7628 403 -7629 402 -7630 403 -7631 403 -7632 402 -7633 403 -7634 403 -7635 402 -7636 403 -7637 403 -7638 402 -7639 403 -7640 403 -7641 402 -7642 403 -7643 403 -7644 402 -7645 403 -7646 403 -7647 402 -7648 403 -7649 403 -7650 402 -7651 403 -7652 403 -7653 402 -7654 403 -7655 403 -7656 402 -7657 403 -7658 403 -7659 402 -7660 403 -7661 403 -7662 402 -7663 403 -7664 403 -7665 402 -7666 403 -7667 403 -7668 402 -7669 403 -7670 403 -7671 402 -7672 403 -7673 403 -7674 402 -7675 403 -7676 403 -7677 402 -7678 403 -7679 403 -7680 402 -7681 403 -7682 403 -7683 402 -7684 403 -7685 403 -7686 402 -7687 403 -7688 403 -7689 402 -7690 403 -7691 403 -7692 402 -7693 403 -7694 403 -7695 402 -7696 403 -7697 403 -7698 402 -7699 403 -7700 403 -7701 402 -7702 403 -7703 403 -7704 402 -7705 403 -7706 403 -7707 402 -7708 403 -7709 403 -7710 402 -7711 403 -7712 403 -7713 402 -7714 403 -7715 403 -7716 402 -7717 403 -7718 403 -7719 402 -7720 403 -7721 403 -7722 402 -7723 403 -7724 403 -7725 402 -7726 403 -7727 403 -7728 402 -7729 403 -7730 403 -7731 402 -7732 403 -7733 403 -7734 402 -7735 403 -7736 403 -7737 402 -7738 403 -7739 403 -7740 402 -7741 403 -7742 403 -7743 402 -7744 403 -7745 403 -7746 402 -7747 403 -7748 403 -7749 402 -7750 403 -7751 403 -7752 402 -7753 403 -7754 403 -7755 402 -7756 403 -7757 403 -7758 402 -7759 403 -7760 403 -7761 402 -7762 403 -7763 403 -7764 402 -7765 403 -7766 403 -7767 402 -7768 403 -7769 403 -7770 402 -7771 403 -7772 403 -7773 402 -7774 403 -7775 403 -7776 402 -7777 403 -7778 403 -7779 402 -7780 403 -7781 403 -7782 402 -7783 403 -7784 403 -7785 402 -7786 403 -7787 403 -7788 402 -7789 403 -7790 403 -7791 402 -7792 403 -7793 403 -7794 402 -7795 403 -7796 403 -7797 402 -7798 403 -7799 403 -7800 402 -7801 403 -7802 403 -7803 402 -7804 403 -7805 403 -7806 402 -7807 403 -7808 403 -7809 402 -7810 403 -7811 403 -7812 402 -7813 403 -7814 403 -7815 402 -7816 403 -7817 403 -7818 402 -7819 403 -7820 403 -7821 402 -7822 403 -7823 403 -7824 402 -7825 403 -7826 403 -7827 402 -7828 403 -7829 403 -7830 402 -7831 403 -7832 403 -7833 402 -7834 403 -7835 403 -7836 402 -7837 403 -7838 403 -7839 402 -7840 403 -7841 403 -7842 402 -7843 403 -7844 403 -7845 402 -7846 403 -7847 403 -7848 402 -7849 403 -7850 403 -7851 402 -7852 403 -7853 403 -7854 402 -7855 403 -7856 403 -7857 402 -7858 403 -7859 403 -7860 402 -7861 403 -7862 403 -7863 402 -7864 403 -7865 403 -7866 402 -7867 403 -7868 403 -7869 402 -7870 403 -7871 403 -7872 402 -7873 403 -7874 403 -7875 402 -7876 403 -7877 403 -7878 402 -7879 403 -7880 403 -7881 402 -7882 403 -7883 403 -7884 402 -7885 403 -7886 403 -7887 402 -7888 403 -7889 403 -7890 402 -7891 403 -7892 403 -7893 402 -7894 403 -7895 403 -7896 402 -7897 403 -7898 403 -7899 402 -7900 403 -7901 403 -7902 402 -7903 403 -7904 403 -7905 402 -7906 403 -7907 403 -7908 402 -7909 403 -7910 403 -7911 402 -7912 403 -7913 403 -7914 402 -7915 403 -7916 403 -7917 402 -7918 403 -7919 403 -7920 402 -7921 403 -7922 403 -7923 402 -7924 403 -7925 403 -7926 402 -7927 403 -7928 403 -7929 402 -7930 403 -7931 403 -7932 402 -7933 403 -7934 403 -7935 402 -7936 403 -7937 403 -7938 402 -7939 403 -7940 403 -7941 402 -7942 403 -7943 403 -7944 402 -7945 403 -7946 403 -7947 402 -7948 403 -7949 403 -7950 402 -7951 403 -7952 403 -7953 402 -7954 403 -7955 403 -7956 402 -7957 403 -7958 403 -7959 402 -7960 403 -7961 403 -7962 402 -7963 403 -7964 403 -7965 402 -7966 403 -7967 403 -7968 402 -7969 403 -7970 403 -7971 402 -7972 403 -7973 403 -7974 402 -7975 403 -7976 403 -7977 402 -7978 403 -7979 403 -7980 402 -7981 403 -7982 403 -7983 402 -7984 403 -7985 403 -7986 402 -7987 403 -7988 403 -7989 402 -7990 403 -7991 403 -7992 402 -7993 403 -7994 403 -7995 402 -7996 403 -7997 403 -7998 402 -7999 403 -8000 403 -8001 402 -8002 403 -8003 403 -8004 402 -8005 403 -8006 403 -8007 402 -8008 403 -8009 403 -8010 402 -8011 403 -8012 403 -8013 402 -8014 403 -8015 403 -8016 402 -8017 403 -8018 403 -8019 402 -8020 403 -8021 403 -8022 402 -8023 403 -8024 403 -8025 402 -8026 403 -8027 403 -8028 402 -8029 403 -8030 403 -8031 402 -8032 403 -8033 403 -8034 402 -8035 403 -8036 403 -8037 402 -8038 403 -8039 403 -8040 402 -8041 403 -8042 403 -8043 402 -8044 403 -8045 403 -8046 402 -8047 403 -8048 403 -8049 402 -8050 403 -8051 403 -8052 402 -8053 403 -8054 403 -8055 402 -8056 403 -8057 403 -8058 402 -8059 403 -8060 403 -8061 402 -8062 403 -8063 403 -8064 402 -8065 403 -8066 403 -8067 402 -8068 403 -8069 403 -8070 402 -8071 403 -8072 403 -8073 402 -8074 403 -8075 403 -8076 402 -8077 403 -8078 403 -8079 402 -8080 403 -8081 403 -8082 402 -8083 403 -8084 403 -8085 402 -8086 403 -8087 403 -8088 402 -8089 403 -8090 403 -8091 402 -8092 403 -8093 403 -8094 402 -8095 403 -8096 403 -8097 402 -8098 403 -8099 403 -8100 402 -8101 403 -8102 403 -8103 402 -8104 403 -8105 403 -8106 402 -8107 403 -8108 403 -8109 402 -8110 403 -8111 403 -8112 402 -8113 403 -8114 403 -8115 402 -8116 403 -8117 403 -8118 402 -8119 403 -8120 403 -8121 402 -8122 403 -8123 403 -8124 402 -8125 403 -8126 403 -8127 402 -8128 403 -8129 403 -8130 402 -8131 403 -8132 403 -8133 402 -8134 403 -8135 403 -8136 402 -8137 403 -8138 403 -8139 402 -8140 403 -8141 403 -8142 402 -8143 403 -8144 403 -8145 402 -8146 403 -8147 403 -8148 402 -8149 403 -8150 403 -8151 402 -8152 403 -8153 403 -8154 402 -8155 403 -8156 403 -8157 402 -8158 403 -8159 403 -8160 402 -8161 403 -8162 403 -8163 402 -8164 403 -8165 403 -8166 402 -8167 403 -8168 403 -8169 402 -8170 403 -8171 403 -8172 402 -8173 403 -8174 403 -8175 402 -8176 403 -8177 403 -8178 402 -8179 403 -8180 403 -8181 402 -8182 403 -8183 403 -8184 402 -8185 403 -8186 403 -8187 402 -8188 403 -8189 403 -8190 402 -8191 403 -8192 403 -8193 402 -8194 403 -8195 403 -8196 402 -8197 403 -8198 403 -8199 402 -8200 403 -8201 403 -8202 402 -8203 403 -8204 403 -8205 402 -8206 403 -8207 403 -8208 402 -8209 403 -8210 403 -8211 402 -8212 403 -8213 403 -8214 402 -8215 403 -8216 403 -8217 402 -8218 403 -8219 403 -8220 402 -8221 403 -8222 403 -8223 402 -8224 403 -8225 403 -8226 402 -8227 403 -8228 403 -8229 402 -8230 403 -8231 403 -8232 402 -8233 403 -8234 403 -8235 402 -8236 403 -8237 403 -8238 402 -8239 403 -8240 403 -8241 402 -8242 403 -8243 403 -8244 402 -8245 403 -8246 403 -8247 402 -8248 403 -8249 403 -8250 402 -8251 403 -8252 403 -8253 402 -8254 403 -8255 403 -8256 402 -8257 403 -8258 403 -8259 402 -8260 403 -8261 403 -8262 402 -8263 403 -8264 403 -8265 402 -8266 403 -8267 403 -8268 402 -8269 403 -8270 403 -8271 402 -8272 403 -8273 403 -8274 402 -8275 403 -8276 403 -8277 402 -8278 403 -8279 403 -8280 402 -8281 403 -8282 403 -8283 402 -8284 403 -8285 403 -8286 402 -8287 403 -8288 403 -8289 402 -8290 403 -8291 403 -8292 402 -8293 403 -8294 403 -8295 402 -8296 403 -8297 403 -8298 402 -8299 403 -8300 403 -8301 402 -8302 403 -8303 403 -8304 402 -8305 403 -8306 403 -8307 402 -8308 403 -8309 403 -8310 402 -8311 403 -8312 403 -8313 402 -8314 403 -8315 403 -8316 402 -8317 403 -8318 403 -8319 402 -8320 403 -8321 403 -8322 402 -8323 403 -8324 403 -8325 402 -8326 403 -8327 403 -8328 402 -8329 403 -8330 403 -8331 402 -8332 403 -8333 403 -8334 402 -8335 403 -8336 403 -8337 402 -8338 403 -8339 403 -8340 402 -8341 403 -8342 403 -8343 402 -8344 403 -8345 403 -8346 402 -8347 403 -8348 403 -8349 402 -8350 403 -8351 403 -8352 402 -8353 403 -8354 403 -8355 402 -8356 403 -8357 403 -8358 402 -8359 403 -8360 403 -8361 402 -8362 403 -8363 403 -8364 402 -8365 403 -8366 403 -8367 402 -8368 403 -8369 403 -8370 402 -8371 403 -8372 403 -8373 402 -8374 403 -8375 403 -8376 402 -8377 403 -8378 403 -8379 402 -8380 403 -8381 403 -8382 402 -8383 403 -8384 403 -8385 402 -8386 403 -8387 403 -8388 402 -8389 403 -8390 403 -8391 402 -8392 403 -8393 403 -8394 402 -8395 403 -8396 403 -8397 402 -8398 403 -8399 403 -8400 402 -8401 403 -8402 403 -8403 402 -8404 403 -8405 403 -8406 402 -8407 403 -8408 403 -8409 402 -8410 403 -8411 403 -8412 402 -8413 403 -8414 403 -8415 402 -8416 403 -8417 403 -8418 402 -8419 403 -8420 403 -8421 402 -8422 403 -8423 403 -8424 402 -8425 403 -8426 403 -8427 402 -8428 403 -8429 403 -8430 402 -8431 403 -8432 403 -8433 402 -8434 403 -8435 403 -8436 402 -8437 403 -8438 403 -8439 402 -8440 403 -8441 403 -8442 402 -8443 403 -8444 403 -8445 402 -8446 403 -8447 403 -8448 402 -8449 403 -8450 403 -8451 402 -8452 403 -8453 403 -8454 402 -8455 403 -8456 403 -8457 402 -8458 403 -8459 403 -8460 402 -8461 403 -8462 403 -8463 402 -8464 403 -8465 403 -8466 402 -8467 403 -8468 403 -8469 402 -8470 403 -8471 403 -8472 402 -8473 403 -8474 403 -8475 402 -8476 403 -8477 403 -8478 402 -8479 403 -8480 403 -8481 402 -8482 403 -8483 403 -8484 402 -8485 403 -8486 403 -8487 402 -8488 403 -8489 403 -8490 402 -8491 403 -8492 403 -8493 402 -8494 403 -8495 403 -8496 402 -8497 403 -8498 403 -8499 402 -8500 403 -8501 403 -8502 402 -8503 403 -8504 403 -8505 402 -8506 403 -8507 403 -8508 402 -8509 403 -8510 403 -8511 402 -8512 403 -8513 403 -8514 402 -8515 403 -8516 403 -8517 402 -8518 403 -8519 403 -8520 402 -8521 403 -8522 403 -8523 402 -8524 403 -8525 403 -8526 402 -8527 403 -8528 403 -8529 402 -8530 403 -8531 403 -8532 402 -8533 403 -8534 403 -8535 402 -8536 403 -8537 403 -8538 402 -8539 403 -8540 403 -8541 402 -8542 403 -8543 403 -8544 402 -8545 403 -8546 403 -8547 402 -8548 403 -8549 403 -8550 402 -8551 403 -8552 403 -8553 402 -8554 403 -8555 403 -8556 402 -8557 403 -8558 403 -8559 402 -8560 403 -8561 403 -8562 402 -8563 403 -8564 403 -8565 402 -8566 403 -8567 403 -8568 402 -8569 403 -8570 403 -8571 402 -8572 403 -8573 403 -8574 402 -8575 403 -8576 403 -8577 402 -8578 403 -8579 403 -8580 402 -8581 403 -8582 403 -8583 402 -8584 403 -8585 403 -8586 402 -8587 403 -8588 403 -8589 402 -8590 403 -8591 403 -8592 402 -8593 403 -8594 403 -8595 402 -8596 403 -8597 403 -8598 402 -8599 403 -8600 403 -8601 402 -8602 403 -8603 403 -8604 402 -8605 403 -8606 403 -8607 402 -8608 403 -8609 403 -8610 402 -8611 403 -8612 403 -8613 402 -8614 403 -8615 403 -8616 402 -8617 403 -8618 403 -8619 402 -8620 403 -8621 403 -8622 402 -8623 403 -8624 403 -8625 402 -8626 403 -8627 403 -8628 402 -8629 403 -8630 403 -8631 402 -8632 403 -8633 403 -8634 402 -8635 403 -8636 403 -8637 402 -8638 403 -8639 403 -8640 402 -8641 403 -8642 403 -8643 402 -8644 403 -8645 403 -8646 402 -8647 403 -8648 403 -8649 402 -8650 403 -8651 403 -8652 402 -8653 403 -8654 403 -8655 402 -8656 403 -8657 403 -8658 402 -8659 403 -8660 403 -8661 402 -8662 403 -8663 403 -8664 402 -8665 403 -8666 403 -8667 402 -8668 403 -8669 403 -8670 402 -8671 403 -8672 403 -8673 402 -8674 403 -8675 403 -8676 402 -8677 403 -8678 403 -8679 402 -8680 403 -8681 403 -8682 402 -8683 403 -8684 403 -8685 402 -8686 403 -8687 403 -8688 402 -8689 403 -8690 403 -8691 402 -8692 403 -8693 403 -8694 402 -8695 403 -8696 403 -8697 402 -8698 403 -8699 403 -8700 402 -8701 403 -8702 403 -8703 402 -8704 403 -8705 403 -8706 402 -8707 403 -8708 403 -8709 402 -8710 403 -8711 403 -8712 402 -8713 403 -8714 403 -8715 402 -8716 403 -8717 403 -8718 402 -8719 403 -8720 403 -8721 402 -8722 403 -8723 403 -8724 402 -8725 403 -8726 403 -8727 402 -8728 403 -8729 403 -8730 402 -8731 403 -8732 403 -8733 402 -8734 403 -8735 403 -8736 402 -8737 403 -8738 403 -8739 402 -8740 403 -8741 403 -8742 402 -8743 403 -8744 403 -8745 402 -8746 403 -8747 403 -8748 402 -8749 403 -8750 403 -8751 402 -8752 403 -8753 403 -8754 402 -8755 403 -8756 403 -8757 402 -8758 403 -8759 403 -8760 402 -8761 403 -8762 403 -8763 402 -8764 403 -8765 403 -8766 402 -8767 403 -8768 403 -8769 402 -8770 403 -8771 403 -8772 402 -8773 403 -8774 403 -8775 402 -8776 403 -8777 403 -8778 402 -8779 403 -8780 403 -8781 402 -8782 403 -8783 403 -8784 402 -8785 403 -8786 403 -8787 402 -8788 403 -8789 403 -8790 402 -8791 403 -8792 403 -8793 402 -8794 403 -8795 403 -8796 402 -8797 403 -8798 403 -8799 402 -8800 403 -8801 403 -8802 402 -8803 403 -8804 403 -8805 402 -8806 403 -8807 403 -8808 402 -8809 403 -8810 403 -8811 402 -8812 403 -8813 403 -8814 402 -8815 403 -8816 403 -8817 402 -8818 403 -8819 403 -8820 402 -8821 403 -8822 403 -8823 402 -8824 403 -8825 403 -8826 402 -8827 403 -8828 403 -8829 402 -8830 403 -8831 403 -8832 402 -8833 403 -8834 403 -8835 402 -8836 403 -8837 403 -8838 402 -8839 403 -8840 403 -8841 402 -8842 403 -8843 403 -8844 402 -8845 403 -8846 403 -8847 402 -8848 403 -8849 403 -8850 402 -8851 403 -8852 403 -8853 402 -8854 403 -8855 403 -8856 402 -8857 403 -8858 403 -8859 402 -8860 403 -8861 403 -8862 402 -8863 403 -8864 403 -8865 402 -8866 403 -8867 403 -8868 402 -8869 403 -8870 403 -8871 402 -8872 403 -8873 403 -8874 402 -8875 403 -8876 403 -8877 402 -8878 403 -8879 403 -8880 402 -8881 403 -8882 403 -8883 402 -8884 403 -8885 403 -8886 402 -8887 403 -8888 403 -8889 402 -8890 403 -8891 403 -8892 402 -8893 403 -8894 403 -8895 402 -8896 403 -8897 403 -8898 402 -8899 403 -8900 403 -8901 402 -8902 403 -8903 403 -8904 402 -8905 403 -8906 403 -8907 402 -8908 403 -8909 403 -8910 402 -8911 403 -8912 403 -8913 402 -8914 403 -8915 403 -8916 402 -8917 403 -8918 403 -8919 402 -8920 403 -8921 403 -8922 402 -8923 403 -8924 403 -8925 402 -8926 403 -8927 403 -8928 402 -8929 403 -8930 403 -8931 402 -8932 403 -8933 403 -8934 402 -8935 403 -8936 403 -8937 402 -8938 403 -8939 403 -8940 402 -8941 403 -8942 403 -8943 402 -8944 403 -8945 403 -8946 402 -8947 403 -8948 403 -8949 402 -8950 403 -8951 403 -8952 402 -8953 403 -8954 403 -8955 402 -8956 403 -8957 403 -8958 402 -8959 403 -8960 403 -8961 402 -8962 403 -8963 403 -8964 402 -8965 403 -8966 403 -8967 402 -8968 403 -8969 403 -8970 402 -8971 403 -8972 403 -8973 402 -8974 403 -8975 403 -8976 402 -8977 403 -8978 403 -8979 402 -8980 403 -8981 403 -8982 402 -8983 403 -8984 403 -8985 402 -8986 403 -8987 403 -8988 402 -8989 403 -8990 403 -8991 402 -8992 403 -8993 403 -8994 402 -8995 403 -8996 403 -8997 402 -8998 403 -8999 403 -9000 402 -9001 403 -9002 403 -9003 402 -9004 403 -9005 403 -9006 402 -9007 403 -9008 403 -9009 402 -9010 403 -9011 403 -9012 402 -9013 403 -9014 403 -9015 402 -9016 403 -9017 403 -9018 402 -9019 403 -9020 403 -9021 402 -9022 403 -9023 403 -9024 402 -9025 403 -9026 403 -9027 402 -9028 403 -9029 403 -9030 402 -9031 403 -9032 403 -9033 402 -9034 403 -9035 403 -9036 402 -9037 403 -9038 403 -9039 402 -9040 403 -9041 403 -9042 402 -9043 403 -9044 403 -9045 402 -9046 403 -9047 403 -9048 402 -9049 403 -9050 403 -9051 402 -9052 403 -9053 403 -9054 402 -9055 403 -9056 403 -9057 402 -9058 403 -9059 403 -9060 402 -9061 403 -9062 403 -9063 402 -9064 403 -9065 403 -9066 402 -9067 403 -9068 403 -9069 402 -9070 403 -9071 403 -9072 402 -9073 403 -9074 403 -9075 402 -9076 403 -9077 403 -9078 402 -9079 403 -9080 403 -9081 402 -9082 403 -9083 403 -9084 402 -9085 403 -9086 403 -9087 402 -9088 403 -9089 403 -9090 402 -9091 403 -9092 403 -9093 402 -9094 403 -9095 403 -9096 402 -9097 403 -9098 403 -9099 402 -9100 403 -9101 403 -9102 402 -9103 403 -9104 403 -9105 402 -9106 403 -9107 403 -9108 402 -9109 403 -9110 403 -9111 402 -9112 403 -9113 403 -9114 402 -9115 403 -9116 403 -9117 402 -9118 403 -9119 403 -9120 402 -9121 403 -9122 403 -9123 402 -9124 403 -9125 403 -9126 402 -9127 403 -9128 403 -9129 402 -9130 403 -9131 403 -9132 402 -9133 403 -9134 403 -9135 402 -9136 403 -9137 403 -9138 402 -9139 403 -9140 403 -9141 402 -9142 403 -9143 403 -9144 402 -9145 403 -9146 403 -9147 402 -9148 403 -9149 403 -9150 402 -9151 403 -9152 403 -9153 402 -9154 403 -9155 403 -9156 402 -9157 403 -9158 403 -9159 402 -9160 403 -9161 403 -9162 402 -9163 403 -9164 403 -9165 402 -9166 403 -9167 403 -9168 402 -9169 403 -9170 403 -9171 402 -9172 403 -9173 403 -9174 402 -9175 403 -9176 403 -9177 402 -9178 403 -9179 403 -9180 402 -9181 403 -9182 403 -9183 402 -9184 403 -9185 403 -9186 402 -9187 403 -9188 403 -9189 402 -9190 403 -9191 403 -9192 402 -9193 403 -9194 403 -9195 402 -9196 403 -9197 403 -9198 402 -9199 403 -9200 403 -9201 402 -9202 403 -9203 403 -9204 402 -9205 403 -9206 403 -9207 402 -9208 403 -9209 403 -9210 402 -9211 403 -9212 403 -9213 402 -9214 403 -9215 403 -9216 402 -9217 403 -9218 403 -9219 402 -9220 403 -9221 403 -9222 402 -9223 403 -9224 403 -9225 402 -9226 403 -9227 403 -9228 402 -9229 403 -9230 403 -9231 402 -9232 403 -9233 403 -9234 402 -9235 403 -9236 403 -9237 402 -9238 403 -9239 403 -9240 402 -9241 403 -9242 403 -9243 402 -9244 403 -9245 403 -9246 402 -9247 403 -9248 403 -9249 402 -9250 403 -9251 403 -9252 402 -9253 403 -9254 403 -9255 402 -9256 403 -9257 403 -9258 402 -9259 403 -9260 403 -9261 402 -9262 403 -9263 403 -9264 402 -9265 403 -9266 403 -9267 402 -9268 403 -9269 403 -9270 402 -9271 403 -9272 403 -9273 402 -9274 403 -9275 403 -9276 402 -9277 403 -9278 403 -9279 402 -9280 403 -9281 403 -9282 402 -9283 403 -9284 403 -9285 402 -9286 403 -9287 403 -9288 402 -9289 403 -9290 403 -9291 402 -9292 403 -9293 403 -9294 402 -9295 403 -9296 403 -9297 402 -9298 403 -9299 403 -9300 402 -9301 403 -9302 403 -9303 402 -9304 403 -9305 403 -9306 402 -9307 403 -9308 403 -9309 402 -9310 403 -9311 403 -9312 402 -9313 403 -9314 403 -9315 402 -9316 403 -9317 403 -9318 402 -9319 403 -9320 403 -9321 402 -9322 403 -9323 403 -9324 402 -9325 403 -9326 403 -9327 402 -9328 403 -9329 403 -9330 402 -9331 403 -9332 403 -9333 402 -9334 403 -9335 403 -9336 402 -9337 403 -9338 403 -9339 402 -9340 403 -9341 403 -9342 402 -9343 403 -9344 403 -9345 402 -9346 403 -9347 403 -9348 402 -9349 403 -9350 403 -9351 402 -9352 403 -9353 403 -9354 402 -9355 403 -9356 403 -9357 402 -9358 403 -9359 403 -9360 402 -9361 403 -9362 403 -9363 402 -9364 403 -9365 403 -9366 402 -9367 403 -9368 403 -9369 402 -9370 403 -9371 403 -9372 402 -9373 403 -9374 403 -9375 402 -9376 403 -9377 403 -9378 402 -9379 403 -9380 403 -9381 402 -9382 403 -9383 403 -9384 402 -9385 403 -9386 403 -9387 402 -9388 403 -9389 403 -9390 402 -9391 403 -9392 403 -9393 402 -9394 403 -9395 403 -9396 402 -9397 403 -9398 403 -9399 402 -9400 403 -9401 403 -9402 402 -9403 403 -9404 403 -9405 402 -9406 403 -9407 403 -9408 402 -9409 403 -9410 403 -9411 402 -9412 403 -9413 403 -9414 402 -9415 403 -9416 403 -9417 402 -9418 403 -9419 403 -9420 402 -9421 403 -9422 403 -9423 402 -9424 403 -9425 403 -9426 402 -9427 403 -9428 403 -9429 402 -9430 403 -9431 403 -9432 402 -9433 403 -9434 403 -9435 402 -9436 403 -9437 403 -9438 402 -9439 403 -9440 403 -9441 402 -9442 403 -9443 403 -9444 402 -9445 403 -9446 403 -9447 402 -9448 403 -9449 403 -9450 402 -9451 403 -9452 403 -9453 402 -9454 403 -9455 403 -9456 402 -9457 403 -9458 403 -9459 402 -9460 403 -9461 403 -9462 402 -9463 403 -9464 403 -9465 402 -9466 403 -9467 403 -9468 402 -9469 403 -9470 403 -9471 402 -9472 403 -9473 403 -9474 402 -9475 403 -9476 403 -9477 402 -9478 403 -9479 403 -9480 402 -9481 403 -9482 403 -9483 402 -9484 403 -9485 403 -9486 402 -9487 403 -9488 403 -9489 402 -9490 403 -9491 403 -9492 402 -9493 403 -9494 403 -9495 402 -9496 403 -9497 403 -9498 402 -9499 403 -9500 403 -9501 402 -9502 403 -9503 403 -9504 402 -9505 403 -9506 403 -9507 402 -9508 403 -9509 403 -9510 402 -9511 403 -9512 403 -9513 402 -9514 403 -9515 403 -9516 402 -9517 403 -9518 403 -9519 402 -9520 403 -9521 403 -9522 402 -9523 403 -9524 403 -9525 402 -9526 403 -9527 403 -9528 402 -9529 403 -9530 403 -9531 402 -9532 403 -9533 403 -9534 402 -9535 403 -9536 403 -9537 402 -9538 403 -9539 403 -9540 402 -9541 403 -9542 403 -9543 402 -9544 403 -9545 403 -9546 402 -9547 403 -9548 403 -9549 402 -9550 403 -9551 403 -9552 402 -9553 403 -9554 403 -9555 402 -9556 403 -9557 403 -9558 402 -9559 403 -9560 403 -9561 402 -9562 403 -9563 403 -9564 402 -9565 403 -9566 403 -9567 402 -9568 403 -9569 403 -9570 402 -9571 403 -9572 403 -9573 402 -9574 403 -9575 403 -9576 402 -9577 403 -9578 403 -9579 402 -9580 403 -9581 403 -9582 402 -9583 403 -9584 403 -9585 402 -9586 403 -9587 403 -9588 402 -9589 403 -9590 403 -9591 402 -9592 403 -9593 403 -9594 402 -9595 403 -9596 403 -9597 402 -9598 403 -9599 403 -9600 402 -9601 403 -9602 403 -9603 402 -9604 403 -9605 403 -9606 402 -9607 403 -9608 403 -9609 402 -9610 403 -9611 403 -9612 402 -9613 403 -9614 403 -9615 402 -9616 403 -9617 403 -9618 402 -9619 403 -9620 403 -9621 402 -9622 403 -9623 403 -9624 402 -9625 403 -9626 403 -9627 402 -9628 403 -9629 403 -9630 402 -9631 403 -9632 403 -9633 402 -9634 403 -9635 403 -9636 402 -9637 403 -9638 403 -9639 402 -9640 403 -9641 403 -9642 402 -9643 403 -9644 403 -9645 402 -9646 403 -9647 403 -9648 402 -9649 403 -9650 403 -9651 402 -9652 403 -9653 403 -9654 402 -9655 403 -9656 403 -9657 402 -9658 403 -9659 403 -9660 402 -9661 403 -9662 403 -9663 402 -9664 403 -9665 403 -9666 402 -9667 403 -9668 403 -9669 402 -9670 403 -9671 403 -9672 402 -9673 403 -9674 403 -9675 402 -9676 403 -9677 403 -9678 402 -9679 403 -9680 403 -9681 402 -9682 403 -9683 403 -9684 402 -9685 403 -9686 403 -9687 402 -9688 403 -9689 403 -9690 402 -9691 403 -9692 403 -9693 402 -9694 403 -9695 403 -9696 402 -9697 403 -9698 403 -9699 402 -9700 403 -9701 403 -9702 402 -9703 403 -9704 403 -9705 402 -9706 403 -9707 403 -9708 402 -9709 403 -9710 403 -9711 402 -9712 403 -9713 403 -9714 402 -9715 403 -9716 403 -9717 402 -9718 403 -9719 403 -9720 402 -9721 403 -9722 403 -9723 402 -9724 403 -9725 403 -9726 402 -9727 403 -9728 403 -9729 402 -9730 403 -9731 403 -9732 402 -9733 403 -9734 403 -9735 402 -9736 403 -9737 403 diff --git a/tools/tinker/data.py b/tools/tinker/data.py new file mode 100644 index 0000000000..2932eee8e3 --- /dev/null +++ b/tools/tinker/data.py @@ -0,0 +1,376 @@ +# Pizza.py toolkit, www.cs.sandia.gov/~sjplimp/pizza.html +# Steve Plimpton, sjplimp@sandia.gov, Sandia National Laboratories +# +# Copyright (2005) Sandia Corporation. Under the terms of Contract +# DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains +# certain rights in this software. This software is distributed under +# the GNU General Public License. + +# data tool + +oneline = "Read, write, manipulate LAMMPS data files" + +docstr = """ +d = data("data.poly") read a LAMMPS data file, can be gzipped +d = data() create an empty data file + +d.map(1,"id",3,"x") assign names to atom columns (1-N) + +coeffs = d.get("Pair Coeffs") extract info from data file section +q = d.get("Atoms",4) + + 1 arg = all columns returned as 2d array of floats + 2 args = Nth column returned as vector of floats + +d.reorder("Atoms",1,3,2,4,5) reorder columns (1-N) in a data file section + + 1,3,2,4,5 = new order of previous columns, can delete columns this way + +d.title = "My LAMMPS data file" set title of the data file +d.headers["atoms"] = 1500 set a header value +d.sections["Bonds"] = lines set a section to list of lines (with newlines) +d.delete("bonds") delete a keyword or section of data file +d.delete("Bonds") +d.replace("Atoms",5,vec) replace Nth column of section with vector +d.newxyz(dmp,1000) replace xyz in Atoms with xyz of snapshot N + + newxyz assumes id,x,y,z are defined in both data and dump files + also replaces ix,iy,iz if they are defined + +index,time,flag = d.iterator(0/1) loop over single data file snapshot +time,box,atoms,bonds,tris,lines = d.viz(index) return list of viz objects + + iterator() and viz() are compatible with equivalent dump calls + iterator() called with arg = 0 first time, with arg = 1 on subsequent calls + index = timestep index within dump object (only 0 for data file) + time = timestep value (only 0 for data file) + flag = -1 when iteration is done, 1 otherwise + viz() returns info for specified timestep index (must be 0) + time = 0 + box = [xlo,ylo,zlo,xhi,yhi,zhi] + atoms = id,type,x,y,z for each atom as 2d array + bonds = id,type,x1,y1,z1,x2,y2,z2,t1,t2 for each bond as 2d array + NULL if bonds do not exist + tris = NULL + lines = NULL + +d.write("data.new") write a LAMMPS data file +""" + +# History +# 8/05, Steve Plimpton (SNL): original version +# 11/07, added triclinic box support + +# ToDo list + +# Variables +# title = 1st line of data file +# names = dictionary with atom attributes as keys, col #s as values +# headers = dictionary with header name as key, value or tuple as values +# sections = dictionary with section name as key, array of lines as values +# nselect = 1 = # of snapshots + +# Imports and external programs + +from os import popen + +try: tmp = PIZZA_GUNZIP +except: PIZZA_GUNZIP = "gunzip" + +# Class definition + +class data: + + # -------------------------------------------------------------------- + + def __init__(self,*list): + self.nselect = 1 + + if len(list) == 0: + self.title = "LAMMPS data file" + self.names = {} + self.headers = {} + self.sections = {} + return + + file = list[0] + if file[-3:] == ".gz": f = popen("%s -c %s" % (PIZZA_GUNZIP,file),'r') + else: f = open(file) + + self.title = f.readline() + self.names = {} + + headers = {} + while 1: + line = f.readline() + line = line.strip() + if len(line) == 0: + continue + found = 0 + for keyword in hkeywords: + if line.find(keyword) >= 0: + found = 1 + words = line.split() + if keyword == "xlo xhi" or keyword == "ylo yhi" or \ + keyword == "zlo zhi": + headers[keyword] = (float(words[0]),float(words[1])) + elif keyword == "xy xz yz": + headers[keyword] = \ + (float(words[0]),float(words[1]),float(words[2])) + else: + headers[keyword] = int(words[0]) + if not found: + break + + sections = {} + while 1: + found = 0 + for pair in skeywords: + keyword,length = pair[0],pair[1] + if keyword == line: + found = 1 + if not headers.has_key(length): + raise StandardError, \ + "data section %s has no matching header value" % line + f.readline() + list = [] + for i in xrange(headers[length]): list.append(f.readline()) + sections[keyword] = list + if not found: + raise StandardError,"invalid section %s in data file" % line + f.readline() + line = f.readline() + if not line: + break + line = line.strip() + + f.close() + self.headers = headers + self.sections = sections + + # -------------------------------------------------------------------- + # assign names to atom columns + + def map(self,*pairs): + if len(pairs) % 2 != 0: + raise StandardError, "data map() requires pairs of mappings" + for i in range(0,len(pairs),2): + j = i + 1 + self.names[pairs[j]] = pairs[i]-1 + + # -------------------------------------------------------------------- + # extract info from data file fields + + def get(self,*list): + if len(list) == 1: + field = list[0] + array = [] + lines = self.sections[field] + for line in lines: + words = line.split() + values = map(float,words) + array.append(values) + return array + elif len(list) == 2: + field = list[0] + n = list[1] - 1 + vec = [] + lines = self.sections[field] + for line in lines: + words = line.split() + vec.append(float(words[n])) + return vec + else: + raise StandardError, "invalid arguments for data.get()" + + # -------------------------------------------------------------------- + # reorder columns in a data file field + + def reorder(self,name,*order): + n = len(order) + natoms = len(self.sections[name]) + oldlines = self.sections[name] + newlines = natoms*[""] + for index in order: + for i in xrange(len(newlines)): + words = oldlines[i].split() + newlines[i] += words[index-1] + " " + for i in xrange(len(newlines)): + newlines[i] += "\n" + self.sections[name] = newlines + + # -------------------------------------------------------------------- + # replace a column of named section with vector of values + + def replace(self,name,icol,vector): + lines = self.sections[name] + newlines = [] + j = icol - 1 + for i in xrange(len(lines)): + line = lines[i] + words = line.split() + words[j] = str(vector[i]) + newline = ' '.join(words) + '\n' + newlines.append(newline) + self.sections[name] = newlines + + # -------------------------------------------------------------------- + # replace x,y,z in Atoms with x,y,z values from snapshot ntime of dump object + # assumes id,x,y,z are defined in both data and dump files + # also replaces ix,iy,iz if they are defined + + def newxyz(self,dm,ntime): + nsnap = dm.findtime(ntime) + + dm.sort(ntime) + x,y,z = dm.vecs(ntime,"x","y","z") + + self.replace("Atoms",self.names['x']+1,x) + self.replace("Atoms",self.names['y']+1,y) + self.replace("Atoms",self.names['z']+1,z) + + if dm.names.has_key("ix") and self.names.has_key("ix"): + ix,iy,iz = dm.vecs(ntime,"ix","iy","iz") + self.replace("Atoms",self.names['ix']+1,ix) + self.replace("Atoms",self.names['iy']+1,iy) + self.replace("Atoms",self.names['iz']+1,iz) + + # -------------------------------------------------------------------- + # delete header value or section from data file + + def delete(self,keyword): + + if self.headers.has_key(keyword): del self.headers[keyword] + elif self.sections.has_key(keyword): del self.sections[keyword] + else: raise StandardError, "keyword not found in data object" + + # -------------------------------------------------------------------- + # write out a LAMMPS data file + + def write(self,file): + f = open(file,"w") + print >>f,self.title + for keyword in hkeywords: + if self.headers.has_key(keyword): + if keyword == "xlo xhi" or keyword == "ylo yhi" or \ + keyword == "zlo zhi": + pair = self.headers[keyword] + print >>f,pair[0],pair[1],keyword + elif keyword == "xy xz yz": + triple = self.headers[keyword] + print >>f,triple[0],triple[1],triple[2],keyword + else: + print >>f,self.headers[keyword],keyword + for pair in skeywords: + keyword = pair[0] + if self.sections.has_key(keyword): + print >>f,"\n%s\n" % keyword + for line in self.sections[keyword]: + print >>f,line, + f.close() + + # -------------------------------------------------------------------- + # iterator called from other tools + + def iterator(self,flag): + if flag == 0: return 0,0,1 + return 0,0,-1 + + # -------------------------------------------------------------------- + # time query from other tools + + def findtime(self,n): + if n == 0: return 0 + raise StandardError, "no step %d exists" % (n) + + # -------------------------------------------------------------------- + # return list of atoms and bonds to viz for data object + + def viz(self,isnap): + if isnap: raise StandardError, "cannot call data.viz() with isnap != 0" + + id = self.names["id"] + type = self.names["type"] + x = self.names["x"] + y = self.names["y"] + z = self.names["z"] + + xlohi = self.headers["xlo xhi"] + ylohi = self.headers["ylo yhi"] + zlohi = self.headers["zlo zhi"] + box = [xlohi[0],ylohi[0],zlohi[0],xlohi[1],ylohi[1],zlohi[1]] + + # create atom list needed by viz from id,type,x,y,z + + atoms = [] + atomlines = self.sections["Atoms"] + for line in atomlines: + words = line.split() + atoms.append([int(words[id]),int(words[type]), + float(words[x]),float(words[y]),float(words[z])]) + + # create list of current bond coords from list of bonds + # assumes atoms are sorted so can lookup up the 2 atoms in each bond + + bonds = [] + if self.sections.has_key("Bonds"): + bondlines = self.sections["Bonds"] + for line in bondlines: + words = line.split() + bid,btype = int(words[0]),int(words[1]) + atom1,atom2 = int(words[2]),int(words[3]) + atom1words = atomlines[atom1-1].split() + atom2words = atomlines[atom2-1].split() + bonds.append([bid,btype, + float(atom1words[x]),float(atom1words[y]), + float(atom1words[z]), + float(atom2words[x]),float(atom2words[y]), + float(atom2words[z]), + float(atom1words[type]),float(atom2words[type])]) + + tris = [] + lines = [] + return 0,box,atoms,bonds,tris,lines + + # -------------------------------------------------------------------- + # return box size + + def maxbox(self): + xlohi = self.headers["xlo xhi"] + ylohi = self.headers["ylo yhi"] + zlohi = self.headers["zlo zhi"] + return [xlohi[0],ylohi[0],zlohi[0],xlohi[1],ylohi[1],zlohi[1]] + + # -------------------------------------------------------------------- + # return number of atom types + + def maxtype(self): + return self.headers["atom types"] + +# -------------------------------------------------------------------- +# data file keywords, both header and main sections + +hkeywords = ["atoms","ellipsoids","lines","triangles","bodies", + "bonds","angles","dihedrals","impropers", + "atom types","bond types","angle types","dihedral types", + "improper types","xlo xhi","ylo yhi","zlo zhi","xy xz yz"] + +skeywords = [["Masses","atom types"], + ["Atoms","atoms"],["Ellipsoids","ellipsoids"], + ["Lines","lines"],["Triangles","triangles"],["Bodies","bodies"], + ["Bonds","bonds"], + ["Angles","angles"],["Dihedrals","dihedrals"], + ["Impropers","impropers"],["Velocities","atoms"], + ["Pair Coeffs","atom types"], + ["Bond Coeffs","bond types"],["Angle Coeffs","angle types"], + ["Dihedral Coeffs","dihedral types"], + ["Improper Coeffs","improper types"], + ["BondBond Coeffs","angle types"], + ["BondAngle Coeffs","angle types"], + ["MiddleBondTorsion Coeffs","dihedral types"], + ["EndBondTorsion Coeffs","dihedral types"], + ["AngleTorsion Coeffs","dihedral types"], + ["AngleAngleTorsion Coeffs","dihedral types"], + ["BondBond13 Coeffs","dihedral types"], + ["AngleAngle Coeffs","improper types"], + ["Molecules","atoms"]] diff --git a/tools/tinker2lmp.py b/tools/tinker/tinker2lmp.py similarity index 92% rename from tools/tinker2lmp.py rename to tools/tinker/tinker2lmp.py index d31be0084d..d0233ba8d4 100644 --- a/tools/tinker2lmp.py +++ b/tools/tinker/tinker2lmp.py @@ -107,6 +107,7 @@ class PRMfile: self.angleparams = self.angles() self.bondangleparams = self.bondangles() self.torsionparams = self.torsions() + self.ureyparams = self.ureybonds() self.opbendparams = self.opbend() self.ntypes = len(self.masses) @@ -296,6 +297,32 @@ class PRMfile: iline += 1 return params + # convert PRMfile params to LAMMPS bond_style class2 bond params + # coeffs for K2,K3 = 0.0 since Urey-Bradley is simple harmonic + + def ureybonds(self): + params = [] + iline = self.find_section("Urey-Bradley Parameters") + if iline < 0: return params + iline += 3 + + while iline < self.nlines: + words = self.lines[iline].split() + if len(words): + if words[0].startswith("###########"): break + if words[0] == "ureybrad": + class1 = int(words[1]) + class2 = int(words[2]) + class3 = int(words[3]) + value1 = float(words[4]) + value2 = float(words[5]) + lmp1 = value1 + lmp2 = value2 + + params.append((class1,class2,class3,lmp1,lmp2,0.0,0.0)) + iline += 1 + return params + # Dihedral interactions def torsions(self): @@ -504,7 +531,7 @@ for i in id: stack.append(k) # ---------------------------------------- -# create lists of bonds, angles, dihedrals +# create lists of bonds, angles, dihedrals, impropers # ---------------------------------------- # create blist = list of bonds @@ -583,6 +610,35 @@ for atom2 in id: if atom3 >= atom4: continue olist.append((atom1,atom2,atom3,atom4)) +# ---------------------------------------- +# create list of Urey-Bradley triplet matches +# ---------------------------------------- + +# scan list of angles to find triplets that match UB parameters +# if match, add it to UB bond list + +type = xyz.type +classes = prm.classes + +ublist = [] + +ubdict = {} +for m,params in enumerate(prm.ureyparams): + ubdict[(params[0],params[1],params[2])] = (m,params) + +for atom1,atom2,atom3 in alist: + type1 = type[atom1-1] + type2 = type[atom2-1] + type3 = type[atom3-1] + c1 = classes[type1-1] + c2 = classes[type2-1] + c3 = classes[type3-1] + + if (c1,c2,c3) in ubdict: + ublist.append((atom1,atom2,atom3)) + elif (c3,c2,c1) in ubdict: + ublist.append((atom3,atom2,atom1)) + # ---------------------------------------- # create lists of bond/angle/dihedral/improper types # ---------------------------------------- @@ -623,6 +679,44 @@ for atom1,atom2 in blist: flags[m] = len(bparams) btype.append(flags[m]) +# extend btype and bparams with Urey-Bradley H-H bond info +# loop over ublist of UB bonds +# convert prm.ureyparams to a dictionary for efficient searching +# key = (class1,class2,class3) +# value = (M,params) where M is index into prm.ureyparams +# also add the c1,c3 H-H bond to blist + +id = xyz.id +type = xyz.type +classes = prm.classes + +ubdict = {} +for m,params in enumerate(prm.ureyparams): + ubdict[(params[0],params[1],params[2])] = (m,params) + +flags = len(prm.ureyparams)*[0] + +for atom1,atom2,atom3 in ublist: + type1 = type[atom1-1] + type2 = type[atom2-1] + type3 = type[atom3-1] + c1 = classes[type1-1] + c2 = classes[type2-1] + c3 = classes[type3-1] + + if (c1,c2,c3) in ubdict: + m,params = ubdict[(c1,c2,c3)] + blist.append((c1,c3)) + elif (c3,c2,c1) in ubdict: + m,params = ubdict[(c3,c2,c1)] + blist.append((c3,c1)) + + if not flags[m]: + v1,v2,v3,v4 = params[3:] + bparams.append((v1,v2,v3,v4)) + flags[m] = len(bparams) + btype.append(flags[m]) + # generate atype = LAMMPS type of each angle # generate aparams = LAMMPS params for each angle type # flags[i] = which LAMMPS angle type (1-N) the Tinker FF file angle I is From 4deeb15043af88b62765f4a150bbb6baf3b9fbd1 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Fri, 4 Mar 2022 09:36:58 -0700 Subject: [PATCH 071/585] new pitorsion class --- src/AMOEBA/fix_pitorsion.cpp | 940 +++++++++++++++++++++++++++++++++++ src/AMOEBA/fix_pitorsion.h | 165 ++++++ 2 files changed, 1105 insertions(+) create mode 100644 src/AMOEBA/fix_pitorsion.cpp create mode 100644 src/AMOEBA/fix_pitorsion.h diff --git a/src/AMOEBA/fix_pitorsion.cpp b/src/AMOEBA/fix_pitorsion.cpp new file mode 100644 index 0000000000..15f2a8f79d --- /dev/null +++ b/src/AMOEBA/fix_pitorsion.cpp @@ -0,0 +1,940 @@ +// clang-format off +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + https://www.lammps.org/, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +/* ---------------------------------------------------------------------- + Contributing authors: + Xiaohu Hu, CMB/ORNL (hux2@ornl.gov) + David Hyde-Volpe, Tigran Abramyan, and Robert A. Latour (Clemson University) + Chris Lorenz (Kings College-London) + + Implementation of the CHARMM CMAP; adds an extra energy term for the + peptide backbone dihedrals. The tools/ch2lmp/charmm2lammps.pl + conversion script, which generates an extra section in the LAMMPS data + file, is needed in order to generate the info used by this fix style. + + References: + - MacKerell et al., J. Am. Chem. Soc. 126(2004):698-699. + - MacKerell et al., J. Comput. Chem. 25(2004):1400-1415. +------------------------------------------------------------------------- */ + +// read_data data.ubiquitin fix pitorsion pitorsions PiTorsions + + +#include "fix_pitorsion.h" + +#include + +#include +#include "atom.h" +#include "update.h" +#include "respa.h" +#include "domain.h" +#include "force.h" +#include "comm.h" +#include "math_const.h" +#include "memory.h" +#include "error.h" + +using namespace LAMMPS_NS; +using namespace FixConst; +using namespace MathConst; + +#define MAXLINE 256 +#define LISTDELTA 10000 +#define LB_FACTOR 1.5 + +/* ---------------------------------------------------------------------- */ + +FixPiTorsion::FixPiTorsion(LAMMPS *lmp, int narg, char **arg) : + Fix(lmp, narg, arg), + crosstermlist(nullptr), num_crossterm(nullptr), crossterm_type(nullptr), + crossterm_atom1(nullptr), crossterm_atom2(nullptr), crossterm_atom3(nullptr), + crossterm_atom4(nullptr), crossterm_atom5(nullptr), + g_axis(nullptr), cmapgrid(nullptr), d1cmapgrid(nullptr), d2cmapgrid(nullptr), + d12cmapgrid(nullptr) +{ + if (narg != 4) error->all(FLERR,"Illegal fix cmap command"); + + restart_global = 1; + restart_peratom = 1; + energy_global_flag = energy_peratom_flag = 1; + virial_global_flag = virial_peratom_flag = 1; + thermo_energy = thermo_virial = 1; + centroidstressflag = CENTROID_NOTAVAIL; + peratom_freq = 1; + scalar_flag = 1; + global_freq = 1; + extscalar = 1; + extvector = 1; + wd_header = 1; + wd_section = 1; + respa_level_support = 1; + ilevel_respa = 0; + + MPI_Comm_rank(world,&me); + MPI_Comm_size(world,&nprocs); + + // allocate memory for CMAP data + + memory->create(g_axis,CMAPDIM,"cmap:g_axis"); + memory->create(cmapgrid,6,CMAPDIM,CMAPDIM,"cmap:grid"); + memory->create(d1cmapgrid,6,CMAPDIM,CMAPDIM,"cmap:d1grid"); + memory->create(d2cmapgrid,6,CMAPDIM,CMAPDIM,"cmap:d2grid"); + memory->create(d12cmapgrid,6,CMAPDIM,CMAPDIM,"cmap:d12grid"); + + // read and setup CMAP data + + read_grid_map(arg[3]); + + // perform initial allocation of atom-based arrays + // register with Atom class + + num_crossterm = nullptr; + crossterm_type = nullptr; + crossterm_atom1 = nullptr; + crossterm_atom2 = nullptr; + crossterm_atom3 = nullptr; + crossterm_atom4 = nullptr; + crossterm_atom5 = nullptr; + + nmax_previous = 0; + grow_arrays(atom->nmax); + atom->add_callback(Atom::GROW); + atom->add_callback(Atom::RESTART); + + // local list of crossterms + + ncmap = 0; + maxcrossterm = 0; + crosstermlist = nullptr; +} + +/* --------------------------------------------------------------------- */ + +FixCMAP::~FixCMAP() +{ + // unregister callbacks to this fix from Atom class + + atom->delete_callback(id,Atom::GROW); + atom->delete_callback(id,Atom::RESTART); + + memory->destroy(g_axis); + memory->destroy(cmapgrid); + memory->destroy(d1cmapgrid); + memory->destroy(d2cmapgrid); + memory->destroy(d12cmapgrid); + + memory->destroy(crosstermlist); + + memory->destroy(num_crossterm); + memory->destroy(crossterm_type); + memory->destroy(crossterm_atom1); + memory->destroy(crossterm_atom2); + memory->destroy(crossterm_atom3); + memory->destroy(crossterm_atom4); + memory->destroy(crossterm_atom5); +} + +/* ---------------------------------------------------------------------- */ + +int FixCMAP::setmask() +{ + int mask = 0; + mask |= PRE_NEIGHBOR; + mask |= PRE_REVERSE; + mask |= POST_FORCE; + mask |= POST_FORCE_RESPA; + mask |= MIN_POST_FORCE; + return mask; +} + +/* ---------------------------------------------------------------------- */ + +void FixCMAP::init() +{ + int i; + double angle; + + i = 0; + angle = -180.0; + while (angle < 180.0) { + g_axis[i] = angle; + angle += CMAPDX; + i++; + } + + // pre-compute the derivatives of the maps + + for (i = 0; i < 6; i++) + set_map_derivatives(cmapgrid[i],d1cmapgrid[i],d2cmapgrid[i],d12cmapgrid[i]); + + // define newton_bond here in case restart file was read (not data file) + + newton_bond = force->newton_bond; + + if (utils::strmatch(update->integrate_style,"^respa")) { + ilevel_respa = ((Respa *) update->integrate)->nlevels-1; + if (respa_level >= 0) ilevel_respa = MIN(respa_level,ilevel_respa); + } +} + +/* --------------------------------------------------------------------- */ + +void FixCMAP::setup(int vflag) +{ + pre_neighbor(); + + if (utils::strmatch(update->integrate_style,"^verlet")) + post_force(vflag); + else { + ((Respa *) update->integrate)->copy_flevel_f(ilevel_respa); + post_force_respa(vflag,ilevel_respa,0); + ((Respa *) update->integrate)->copy_f_flevel(ilevel_respa); + } +} + +/* --------------------------------------------------------------------- */ + +void FixCMAP::setup_pre_neighbor() +{ + pre_neighbor(); +} + +/* --------------------------------------------------------------------- */ + +void FixCMAP::setup_pre_reverse(int eflag, int vflag) +{ + pre_reverse(eflag,vflag); +} + +/* --------------------------------------------------------------------- */ + +void FixCMAP::min_setup(int vflag) +{ + pre_neighbor(); + post_force(vflag); +} + +/* ---------------------------------------------------------------------- + store local neighbor list as if newton_bond = OFF, even if actually ON +------------------------------------------------------------------------- */ + +void FixCMAP::pre_neighbor() +{ + int i,m,atom1,atom2,atom3,atom4,atom5; + + // guesstimate initial length of local crossterm list + // if ncmap was not set (due to read_restart, no read_data), + // then list will grow by LISTDELTA chunks + + if (maxcrossterm == 0) { + if (nprocs == 1) maxcrossterm = ncmap; + else maxcrossterm = static_cast (LB_FACTOR*ncmap/nprocs); + memory->create(crosstermlist,maxcrossterm,6,"cmap:crosstermlist"); + } + + int nlocal = atom->nlocal; + + ncrosstermlist = 0; + + for (i = 0; i < nlocal; i++) { + for (m = 0; m < num_crossterm[i]; m++) { + atom1 = atom->map(crossterm_atom1[i][m]); + atom2 = atom->map(crossterm_atom2[i][m]); + atom3 = atom->map(crossterm_atom3[i][m]); + atom4 = atom->map(crossterm_atom4[i][m]); + atom5 = atom->map(crossterm_atom5[i][m]); + + if (atom1 == -1 || atom2 == -1 || atom3 == -1 || + atom4 == -1 || atom5 == -1) + error->one(FLERR,"CMAP atoms {} {} {} {} {} missing on " + "proc {} at step {}", + crossterm_atom1[i][m],crossterm_atom2[i][m], + crossterm_atom3[i][m],crossterm_atom4[i][m], + crossterm_atom5[i][m],me,update->ntimestep); + atom1 = domain->closest_image(i,atom1); + atom2 = domain->closest_image(i,atom2); + atom3 = domain->closest_image(i,atom3); + atom4 = domain->closest_image(i,atom4); + atom5 = domain->closest_image(i,atom5); + + if (i <= atom1 && i <= atom2 && i <= atom3 && + i <= atom4 && i <= atom5) { + if (ncrosstermlist == maxcrossterm) { + maxcrossterm += LISTDELTA; + memory->grow(crosstermlist,maxcrossterm,6,"cmap:crosstermlist"); + } + crosstermlist[ncrosstermlist][0] = atom1; + crosstermlist[ncrosstermlist][1] = atom2; + crosstermlist[ncrosstermlist][2] = atom3; + crosstermlist[ncrosstermlist][3] = atom4; + crosstermlist[ncrosstermlist][4] = atom5; + crosstermlist[ncrosstermlist][5] = crossterm_type[i][m]; + ncrosstermlist++; + } + } + } +} + +/* ---------------------------------------------------------------------- + store eflag, so can use it in post_force to tally per-atom energies +------------------------------------------------------------------------- */ + +void FixCMAP::pre_reverse(int eflag, int /*vflag*/) +{ + eflag_caller = eflag; +} + +/* ---------------------------------------------------------------------- + compute PiTorsion terms as if newton_bond = OFF, even if actually ON +------------------------------------------------------------------------- */ + +void FixCMAP::post_force(int vflag) +{ + double **x = atom->x; + double **f = atom->f; + + for (int n = 0; n < npitors; n++) { + ia = ipit[n][0]; + ib = ipit[n][1]; + ic = ipit[n][2]; + id = ipit[n][3]; + ie = ipit[n][4]; + ig = ipit[n][5]; + + // compute the value of the pi-system torsion angle + + xia = x[ia][0]; + yia = x[ia][1]; + zia = x[ia][2]; + xib = x[ib][0]; + yib = x[ib][1]; + zib = x[ib][2]; + xic = x[ic][0]; + yic = x[ic][1]; + zic = x[ic][2]; + xid = x[id][0]; + yid = x[id][1]; + zid = x[id][2]; + xie = x[ie][0]; + yie = x[ie][1]; + zie = x[ie][2]; + xig = x[ig][0]; + yig = x[ig][1]; + zig = x[ig][2]; + + xad = xia - xid; + yad = yia - yid; + zad = zia - zid; + xbd = xib - xid; + ybd = yib - yid; + zbd = zib - zid; + xec = xie - xic; + yec = yie - yic; + zec = zie - zic; + xgc = xig - xic; + ygc = yig - yic; + zgc = zig - zic; + + xip = yad*zbd - ybd*zad + xic; + yip = zad*xbd - zbd*xad + yic; + zip = xad*ybd - xbd*yad + zic; + xiq = yec*zgc - ygc*zec + xid; + yiq = zec*xgc - zgc*xec + yid; + ziq = xec*ygc - xgc*yec + zid; + xcp = xic - xip; + ycp = yic - yip; + zcp = zic - zip; + xdc = xid - xic; + ydc = yid - yic; + zdc = zid - zic; + xqd = xiq - xid; + yqd = yiq - yid; + zqd = ziq - zid; + + xt = ycp*zdc - ydc*zcp; + yt = zcp*xdc - zdc*xcp; + zt = xcp*ydc - xdc*ycp; + xu = ydc*zqd - yqd*zdc; + yu = zdc*xqd - zqd*xdc; + zu = xdc*yqd - xqd*ydc; + xtu = yt*zu - yu*zt; + ytu = zt*xu - zu*xt; + ztu = xt*yu - xu*yt; + rt2 = xt*xt + yt*yt + zt*zt; + ru2 = xu*xu + yu*yu + zu*zu; + rtru = sqrt(rt2*ru2); + + if (rtru <= 0.0) continue; + + rdc = sqrt(xdc*xdc + ydc*ydc + zdc*zdc); + cosine = (xt*xu + yt*yu + zt*zu) / rtru; + sine = (xdc*xtu + ydc*ytu + zdc*ztu) / (rdc*rtru); + + // set the pi-system torsion parameters for this angle + + v2 = kpit(i); + c2 = -1.0; + s2 = 0.0; + + // compute the multiple angle trigonometry and the phase terms + + cosine2 = cosine*cosine - sine*sine; + sine2 = 2.0 * cosine * sine; + phi2 = 1.0 + (cosine2*c2 + sine2*s2); + dphi2 = 2.0 * (cosine2*s2 - sine2*c2); + + // calculate pi-system torsion energy and master chain rule term + + e = ptorunit * v2 * phi2; + dedphi = ptorunit * v2 * dphi2; + + // chain rule terms for first derivative components + + xdp = xid - xip; + ydp = yid - yip; + zdp = zid - zip; + xqc = xiq - xic; + yqc = yiq - yic; + zqc = ziq - zic; + dedxt = dedphi * (yt*zdc - ydc*zt) / (rt2*rdc); + dedyt = dedphi * (zt*xdc - zdc*xt) / (rt2*rdc); + dedzt = dedphi * (xt*ydc - xdc*yt) / (rt2*rdc); + dedxu = -dedphi * (yu*zdc - ydc*zu) / (ru2*rdc); + dedyu = -dedphi * (zu*xdc - zdc*xu) / (ru2*rdc); + dedzu = -dedphi * (xu*ydc - xdc*yu) / (ru2*rdc); + + // compute first derivative components for pi-system angle + + dedxip = zdc*dedyt - ydc*dedzt; + dedyip = xdc*dedzt - zdc*dedxt; + dedzip = ydc*dedxt - xdc*dedyt; + dedxic = ydp*dedzt - zdp*dedyt + zqd*dedyu - yqd*dedzu; + dedyic = zdp*dedxt - xdp*dedzt + xqd*dedzu - zqd*dedxu; + dedzic = xdp*dedyt - ydp*dedxt + yqd*dedxu - xqd*dedyu; + dedxid = zcp*dedyt - ycp*dedzt + yqc*dedzu - zqc*dedyu; + dedyid = xcp*dedzt - zcp*dedxt + zqc*dedxu - xqc*dedzu; + dedzid = ycp*dedxt - xcp*dedyt + xqc*dedyu - yqc*dedxu; + dedxiq = zdc*dedyu - ydc*dedzu; + dedyiq = xdc*dedzu - zdc*dedxu; + dedziq = ydc*dedxu - xdc*dedyu; + + // compute first derivative components for individual atoms + + dedxia = ybd*dedzip - zbd*dedyip; + dedyia = zbd*dedxip - xbd*dedzip; + dedzia = xbd*dedyip - ybd*dedxip; + dedxib = zad*dedyip - yad*dedzip; + dedyib = xad*dedzip - zad*dedxip; + dedzib = yad*dedxip - xad*dedyip; + dedxie = ygc*dedziq - zgc*dedyiq; + dedyie = zgc*dedxiq - xgc*dedziq; + dedzie = xgc*dedyiq - ygc*dedxiq; + dedxig = zec*dedyiq - yec*dedziq; + dedyig = xec*dedziq - zec*dedxiq; + dedzig = yec*dedxiq - xec*dedyiq; + dedxic = dedxic + dedxip - dedxie - dedxig; + dedyic = dedyic + dedyip - dedyie - dedyig; + dedzic = dedzic + dedzip - dedzie - dedzig; + dedxid = dedxid + dedxiq - dedxia - dedxib; + dedyid = dedyid + dedyiq - dedyia - dedyib; + dedzid = dedzid + dedziq - dedzia - dedzib; + + // increment the total pi-system torsion energy and gradient + + ept += e; + + f[ia][0] += dedxia; + f[ia][1] += dedyia; + f[ia][2] += dedzia; + f[ib][0] += dedxib; + f[ib][1] += dedyib; + f[ib][2] += dedzib; + f[ic][0] += dedxic; + f[ic][1] += dedyic; + f[ic][2] += dedzic; + f[id][0] += dedxid; + f[id][1] += dedyid; + f[id][2] += dedzid; + f[ie][0] += dedxie; + f[ie][1] += dedyie; + f[ie][2] += dedzie; + f[ig][0] += dedxig; + f[ig][1] += dedyig; + f[ig][2] += dedzig; + + // increment the internal virial tensor components + + vxterm = dedxid + dedxia + dedxib; + vyterm = dedyid + dedyia + dedyib; + vzterm = dedzid + dedzia + dedzib; + vxx = xdc*vxterm + xcp*dedxip - xqd*dedxiq; + vyx = ydc*vxterm + ycp*dedxip - yqd*dedxiq; + vzx = zdc*vxterm + zcp*dedxip - zqd*dedxiq; + vyy = ydc*vyterm + ycp*dedyip - yqd*dedyiq; + vzy = zdc*vyterm + zcp*dedyip - zqd*dedyiq; + vzz = zdc*vzterm + zcp*dedzip - zqd*dedziq; + + virial[0] += vxx; + virial[1] += vyy; + virial[2] += vzz; + virial[3] += vyx; + virial[4] += vzx; + virial[5] += vzy; + } +} + +/* ---------------------------------------------------------------------- */ + +void FixCMAP::post_force_respa(int vflag, int ilevel, int /*iloop*/) +{ + if (ilevel == ilevel_respa) post_force(vflag); +} + +/* ---------------------------------------------------------------------- */ + +void FixCMAP::min_post_force(int vflag) +{ + post_force(vflag); +} + +/* ---------------------------------------------------------------------- + energy of CMAP term +------------------------------------------------------------------------- */ + +double FixCMAP::compute_scalar() +{ + double all; + MPI_Allreduce(&ecmap,&all,1,MPI_DOUBLE,MPI_SUM,world); + return all; +} + +// ---------------------------------------------------------------------- +// ---------------------------------------------------------------------- +// methods to read and write data file +// ---------------------------------------------------------------------- +// ---------------------------------------------------------------------- + +void FixCMAP::read_data_header(char *line) +{ + if (strstr(line,"pitorsions")) { + sscanf(line,BIGINT_FORMAT,&ncmap); + } else error->all(FLERR,"Invalid read data header line for fix pitorsion"); + + // didn't set in constructor because this fix could be defined + // before newton command + + newton_bond = force->newton_bond; +} + +/* ---------------------------------------------------------------------- + unpack N lines in buf from section of data file labeled by keyword + id_offset is applied to atomID fields if multiple data files are read + store CMAP interactions as if newton_bond = OFF, even if actually ON +------------------------------------------------------------------------- */ + +void FixCMAP::read_data_section(char *keyword, int n, char *buf, + tagint id_offset) +{ + int m,tmp,itype; + tagint atom1,atom2,atom3,atom4,atom5; + char *next; + + next = strchr(buf,'\n'); + *next = '\0'; + int nwords = utils::count_words(utils::trim_comment(buf)); + *next = '\n'; + + if (nwords != 7) + error->all(FLERR,"Incorrect {} format in data file",keyword); + + // loop over lines of PiTorsions + // tokenize the line into values + // add crossterm to one of my atoms, depending on newton_bond + + for (int i = 0; i < n; i++) { + next = strchr(buf,'\n'); + *next = '\0'; + sscanf(buf,"%d %d " TAGINT_FORMAT " " TAGINT_FORMAT " " TAGINT_FORMAT + " " TAGINT_FORMAT " " TAGINT_FORMAT, + &tmp,&itype,&atom1,&atom2,&atom3,&atom4,&atom5); + + atom1 += id_offset; + atom2 += id_offset; + atom3 += id_offset; + atom4 += id_offset; + atom5 += id_offset; + + if ((m = atom->map(atom1)) >= 0) { + if (num_crossterm[m] == CMAPMAX) + error->one(FLERR,"Too many CMAP crossterms for one atom"); + crossterm_type[m][num_crossterm[m]] = itype; + crossterm_atom1[m][num_crossterm[m]] = atom1; + crossterm_atom2[m][num_crossterm[m]] = atom2; + crossterm_atom3[m][num_crossterm[m]] = atom3; + crossterm_atom4[m][num_crossterm[m]] = atom4; + crossterm_atom5[m][num_crossterm[m]] = atom5; + num_crossterm[m]++; + } + + if ((m = atom->map(atom2)) >= 0) { + if (num_crossterm[m] == CMAPMAX) + error->one(FLERR,"Too many CMAP crossterms for one atom"); + crossterm_type[m][num_crossterm[m]] = itype; + crossterm_atom1[m][num_crossterm[m]] = atom1; + crossterm_atom2[m][num_crossterm[m]] = atom2; + crossterm_atom3[m][num_crossterm[m]] = atom3; + crossterm_atom4[m][num_crossterm[m]] = atom4; + crossterm_atom5[m][num_crossterm[m]] = atom5; + num_crossterm[m]++; + } + + if ((m = atom->map(atom3)) >= 0) { + if (num_crossterm[m] == CMAPMAX) + error->one(FLERR,"Too many CMAP crossterms for one atom"); + crossterm_type[m][num_crossterm[m]] = itype; + crossterm_atom1[m][num_crossterm[m]] = atom1; + crossterm_atom2[m][num_crossterm[m]] = atom2; + crossterm_atom3[m][num_crossterm[m]] = atom3; + crossterm_atom4[m][num_crossterm[m]] = atom4; + crossterm_atom5[m][num_crossterm[m]] = atom5; + num_crossterm[m]++; + } + + if ((m = atom->map(atom4)) >= 0) { + if (num_crossterm[m] == CMAPMAX) + error->one(FLERR,"Too many CMAP crossterms for one atom"); + crossterm_type[m][num_crossterm[m]] = itype; + crossterm_atom1[m][num_crossterm[m]] = atom1; + crossterm_atom2[m][num_crossterm[m]] = atom2; + crossterm_atom3[m][num_crossterm[m]] = atom3; + crossterm_atom4[m][num_crossterm[m]] = atom4; + crossterm_atom5[m][num_crossterm[m]] = atom5; + num_crossterm[m]++; + } + + if ((m = atom->map(atom5)) >= 0) { + if (num_crossterm[m] == CMAPMAX) + error->one(FLERR,"Too many CMAP crossterms for one atom"); + crossterm_type[m][num_crossterm[m]] = itype; + crossterm_atom1[m][num_crossterm[m]] = atom1; + crossterm_atom2[m][num_crossterm[m]] = atom2; + crossterm_atom3[m][num_crossterm[m]] = atom3; + crossterm_atom4[m][num_crossterm[m]] = atom4; + crossterm_atom5[m][num_crossterm[m]] = atom5; + num_crossterm[m]++; + } + + buf = next + 1; + } +} + +/* ---------------------------------------------------------------------- */ + +bigint FixCMAP::read_data_skip_lines(char * /*keyword*/) +{ + return ncmap; +} + +/* ---------------------------------------------------------------------- + write Mth header line to file + only called by proc 0 +------------------------------------------------------------------------- */ + +void FixCMAP::write_data_header(FILE *fp, int /*mth*/) +{ + fprintf(fp,BIGINT_FORMAT " cmap crossterms\n",ncmap); +} + +/* ---------------------------------------------------------------------- + return size I own for Mth data section + # of data sections = 1 for this fix + nx = # of crossterms owned by my local atoms + if newton_bond off, atom only owns crossterm if it is atom3 + ny = columns = type + 5 atom IDs +------------------------------------------------------------------------- */ + +void FixCMAP::write_data_section_size(int /*mth*/, int &nx, int &ny) +{ + int i,m; + + tagint *tag = atom->tag; + int nlocal = atom->nlocal; + + nx = 0; + for (i = 0; i < nlocal; i++) + for (m = 0; m < num_crossterm[i]; m++) + if (crossterm_atom3[i][m] == tag[i]) nx++; + + ny = 6; +} + +/* ---------------------------------------------------------------------- + pack values for Mth data section into 2d buf + buf allocated by caller as owned crossterms by 6 +------------------------------------------------------------------------- */ + +void FixCMAP::write_data_section_pack(int /*mth*/, double **buf) +{ + int i,m; + + // 1st column = CMAP type + // 2nd-6th columns = 5 atom IDs + + tagint *tag = atom->tag; + int nlocal = atom->nlocal; + + int n = 0; + for (i = 0; i < nlocal; i++) { + for (m = 0; m < num_crossterm[i]; m++) { + if (crossterm_atom3[i][m] != tag[i]) continue; + buf[n][0] = ubuf(crossterm_type[i][m]).d; + buf[n][1] = ubuf(crossterm_atom1[i][m]).d; + buf[n][2] = ubuf(crossterm_atom2[i][m]).d; + buf[n][3] = ubuf(crossterm_atom3[i][m]).d; + buf[n][4] = ubuf(crossterm_atom4[i][m]).d; + buf[n][5] = ubuf(crossterm_atom5[i][m]).d; + n++; + } + } +} + +/* ---------------------------------------------------------------------- + write section keyword for Mth data section to file + use Molecules or Charges if that is only field, else use fix ID + only called by proc 0 +------------------------------------------------------------------------- */ + +void FixCMAP::write_data_section_keyword(int /*mth*/, FILE *fp) +{ + fprintf(fp,"\nCMAP\n\n"); +} + +/* ---------------------------------------------------------------------- + write N lines from buf to file + convert buf fields to int or double depending on styles + index can be used to prepend global numbering + only called by proc 0 +------------------------------------------------------------------------- */ + +void FixCMAP::write_data_section(int /*mth*/, FILE *fp, + int n, double **buf, int index) +{ + for (int i = 0; i < n; i++) + fprintf(fp,"%d %d " TAGINT_FORMAT " " TAGINT_FORMAT + " " TAGINT_FORMAT " " TAGINT_FORMAT " " TAGINT_FORMAT "\n", + index+i,(int) ubuf(buf[i][0]).i,(tagint) ubuf(buf[i][1]).i, + (tagint) ubuf(buf[i][2]).i,(tagint) ubuf(buf[i][3]).i, + (tagint) ubuf(buf[i][4]).i,(tagint) ubuf(buf[i][5]).i); +} + +// ---------------------------------------------------------------------- +// ---------------------------------------------------------------------- +// methods for restart and communication +// ---------------------------------------------------------------------- +// ---------------------------------------------------------------------- + +/* ---------------------------------------------------------------------- + pack entire state of Fix into one write +------------------------------------------------------------------------- */ + +void FixCMAP::write_restart(FILE *fp) +{ + if (comm->me == 0) { + int size = sizeof(bigint); + fwrite(&size,sizeof(int),1,fp); + fwrite(&ncmap,sizeof(bigint),1,fp); + } +} + +/* ---------------------------------------------------------------------- + use state info from restart file to restart the Fix +------------------------------------------------------------------------- */ + +void FixCMAP::restart(char *buf) +{ + ncmap = *((bigint *) buf); +} + +/* ---------------------------------------------------------------------- + pack values in local atom-based arrays for restart file +------------------------------------------------------------------------- */ + +int FixCMAP::pack_restart(int i, double *buf) +{ + int n = 1; + for (int m = 0; m < num_crossterm[i]; m++) { + buf[n++] = ubuf(MAX(crossterm_type[i][m],-crossterm_type[i][m])).d; + buf[n++] = ubuf(crossterm_atom1[i][m]).d; + buf[n++] = ubuf(crossterm_atom2[i][m]).d; + buf[n++] = ubuf(crossterm_atom3[i][m]).d; + buf[n++] = ubuf(crossterm_atom4[i][m]).d; + buf[n++] = ubuf(crossterm_atom5[i][m]).d; + } + // pack buf[0] this way because other fixes unpack it + buf[0] = n; + + return n; +} + +/* ---------------------------------------------------------------------- + unpack values from atom->extra array to restart the fix +------------------------------------------------------------------------- */ + +void FixCMAP::unpack_restart(int nlocal, int nth) +{ + double **extra = atom->extra; + + // skip to Nth set of extra values + // unpack the Nth first values this way because other fixes pack them + + int n = 0; + for (int i = 0; i < nth; i++) n += static_cast (extra[nlocal][n]); + + int count = static_cast (extra[nlocal][n++]); + num_crossterm[nlocal] = (count-1)/6; + + for (int m = 0; m < num_crossterm[nlocal]; m++) { + crossterm_type[nlocal][m] = (int) ubuf(extra[nlocal][n++]).i; + crossterm_atom1[nlocal][m] = (tagint) ubuf(extra[nlocal][n++]).i; + crossterm_atom2[nlocal][m] = (tagint) ubuf(extra[nlocal][n++]).i; + crossterm_atom3[nlocal][m] = (tagint) ubuf(extra[nlocal][n++]).i; + crossterm_atom4[nlocal][m] = (tagint) ubuf(extra[nlocal][n++]).i; + crossterm_atom5[nlocal][m] = (tagint) ubuf(extra[nlocal][n++]).i; + } +} + +/* ---------------------------------------------------------------------- + maxsize of any atom's restart data +------------------------------------------------------------------------- */ + +int FixCMAP::maxsize_restart() +{ + return 1 + CMAPMAX*6; +} + +/* ---------------------------------------------------------------------- + size of atom nlocal's restart data +------------------------------------------------------------------------- */ + +int FixCMAP::size_restart(int nlocal) +{ + return 1 + num_crossterm[nlocal]*6; +} + +/* ---------------------------------------------------------------------- + allocate atom-based array +------------------------------------------------------------------------- */ + +void FixCMAP::grow_arrays(int nmax) +{ + num_crossterm = memory->grow(num_crossterm,nmax,"cmap:num_crossterm"); + crossterm_type = memory->grow(crossterm_type,nmax,CMAPMAX, + "cmap:crossterm_type"); + crossterm_atom1 = memory->grow(crossterm_atom1,nmax,CMAPMAX, + "cmap:crossterm_atom1"); + crossterm_atom2 = memory->grow(crossterm_atom2,nmax,CMAPMAX, + "cmap:crossterm_atom2"); + crossterm_atom3 = memory->grow(crossterm_atom3,nmax,CMAPMAX, + "cmap:crossterm_atom3"); + crossterm_atom4 = memory->grow(crossterm_atom4,nmax,CMAPMAX, + "cmap:crossterm_atom4"); + crossterm_atom5 = memory->grow(crossterm_atom5,nmax,CMAPMAX, + "cmap:crossterm_atom5"); + + // must initialize num_crossterm to 0 for added atoms + // may never be set for some atoms when data file is read + + for (int i = nmax_previous; i < nmax; i++) num_crossterm[i] = 0; + nmax_previous = nmax; +} + +/* ---------------------------------------------------------------------- + copy values within local atom-based array +------------------------------------------------------------------------- */ + +void FixCMAP::copy_arrays(int i, int j, int /*delflag*/) +{ + num_crossterm[j] = num_crossterm[i]; + + for (int k = 0; k < num_crossterm[j]; k++) { + crossterm_type[j][k] = crossterm_type[i][k]; + crossterm_atom1[j][k] = crossterm_atom1[i][k]; + crossterm_atom2[j][k] = crossterm_atom2[i][k]; + crossterm_atom3[j][k] = crossterm_atom3[i][k]; + crossterm_atom4[j][k] = crossterm_atom4[i][k]; + crossterm_atom5[j][k] = crossterm_atom5[i][k]; + } +} + +/* ---------------------------------------------------------------------- + initialize one atom's array values, called when atom is created +------------------------------------------------------------------------- */ + +void FixCMAP::set_arrays(int i) +{ + num_crossterm[i] = 0; +} + +/* ---------------------------------------------------------------------- + pack values in local atom-based array for exchange with another proc +------------------------------------------------------------------------- */ + +int FixCMAP::pack_exchange(int i, double *buf) +{ + int n = 0; + buf[n++] = ubuf(num_crossterm[i]).d; + for (int m = 0; m < num_crossterm[i]; m++) { + buf[n++] = ubuf(crossterm_type[i][m]).d; + buf[n++] = ubuf(crossterm_atom1[i][m]).d; + buf[n++] = ubuf(crossterm_atom2[i][m]).d; + buf[n++] = ubuf(crossterm_atom3[i][m]).d; + buf[n++] = ubuf(crossterm_atom4[i][m]).d; + buf[n++] = ubuf(crossterm_atom5[i][m]).d; + } + return n; +} + +/* ---------------------------------------------------------------------- + unpack values in local atom-based array from exchange with another proc +------------------------------------------------------------------------- */ + +int FixCMAP::unpack_exchange(int nlocal, double *buf) +{ + int n = 0; + num_crossterm[nlocal] = (int) ubuf(buf[n++]).i; + for (int m = 0; m < num_crossterm[nlocal]; m++) { + crossterm_type[nlocal][m] = (int) ubuf(buf[n++]).i; + crossterm_atom1[nlocal][m] = (tagint) ubuf(buf[n++]).i; + crossterm_atom2[nlocal][m] = (tagint) ubuf(buf[n++]).i; + crossterm_atom3[nlocal][m] = (tagint) ubuf(buf[n++]).i; + crossterm_atom4[nlocal][m] = (tagint) ubuf(buf[n++]).i; + crossterm_atom5[nlocal][m] = (tagint) ubuf(buf[n++]).i; + } + return n; +} + +/* ---------------------------------------------------------------------- + memory usage of local atom-based arrays +------------------------------------------------------------------------- */ + +double FixCMAP::memory_usage() +{ + int nmax = atom->nmax; + double bytes = (double)nmax * sizeof(int); // num_crossterm + bytes += (double)nmax*CMAPMAX * sizeof(int); // crossterm_type + bytes += (double)5*nmax*CMAPMAX * sizeof(int); // crossterm_atom 12345 + bytes += (double)maxcrossterm*6 * sizeof(int); // crosstermlist + return bytes; +} diff --git a/src/AMOEBA/fix_pitorsion.h b/src/AMOEBA/fix_pitorsion.h new file mode 100644 index 0000000000..ae70f9faad --- /dev/null +++ b/src/AMOEBA/fix_pitorsion.h @@ -0,0 +1,165 @@ +/* -*- c++ -*- ---------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + https://www.lammps.org/, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#ifdef FIX_CLASS +// clang-format off +FixStyle(cmap,FixCMAP); +// clang-format on +#else + +#ifndef LMP_FIX_CMAP_H +#define LMP_FIX_CMAP_H + +#include "fix.h" +namespace LAMMPS_NS { + +class FixCMAP : public Fix { + public: + FixCMAP(class LAMMPS *, int, char **); + ~FixCMAP(); + int setmask(); + void init(); + void setup(int); + void setup_pre_neighbor(); + void setup_pre_reverse(int, int); + void min_setup(int); + void pre_neighbor(); + void pre_reverse(int, int); + void post_force(int); + void post_force_respa(int, int, int); + void min_post_force(int); + double compute_scalar(); + + void read_data_header(char *); + void read_data_section(char *, int, char *, tagint); + bigint read_data_skip_lines(char *); + void write_data_header(FILE *, int); + void write_data_section_size(int, int &, int &); + void write_data_section_pack(int, double **); + void write_data_section_keyword(int, FILE *); + void write_data_section(int, FILE *, int, double **, int); + + void write_restart(FILE *); + void restart(char *); + int pack_restart(int, double *); + void unpack_restart(int, int); + int size_restart(int); + int maxsize_restart(); + + void grow_arrays(int); + void copy_arrays(int, int, int); + void set_arrays(int); + int pack_exchange(int, double *); + int unpack_exchange(int, double *); + + double memory_usage(); + + private: + int nprocs, me; + int newton_bond, eflag_caller; + int ctype, ilevel_respa; + int ncrosstermtypes, crossterm_per_atom, maxcrossterm; + int ncrosstermlist; + bigint ncmap; + + int **crosstermlist; + + int nmax_previous; + int *num_crossterm; + int **crossterm_type; + tagint **crossterm_atom1, **crossterm_atom2, **crossterm_atom3; + tagint **crossterm_atom4, **crossterm_atom5; + + double E, dEdPhi, dEdPsi; + double ecmap; + double fcmap[4], cij[4][4]; + double *g_axis; + + // CMAP grid points obtained from external file + + double ***cmapgrid; + + // partial derivatives and cross-derivatives of the grid data + + double ***d1cmapgrid, ***d2cmapgrid, ***d12cmapgrid; + + // read map grid data + + void read_grid_map(char *); + + // read in CMAP cross terms from LAMMPS data file + + void read_cmap_data(int, char *); + + // pre-compute the partial and cross-derivatives of map grid points + + void set_map_derivatives(double **, double **, double **, double **); + + // cubic spline interpolation functions for derivatives of map grid points + + void spline(double *, double *, int); + void spl_interpolate(double, double *, double *, double &, double &); + + // calculate dihedral angles + + double dihedral_angle_atan2(double, double, double, double, double, double, double, double, + double, double); + + // calculate bicubic interpolation coefficient matrix c_ij + + void bc_coeff(double *, double *, double *, double *); + + // perform bicubic interpolation at point of interest + + void bc_interpol(double, double, int, int, double *, double *, double *, double *); +}; +} // namespace LAMMPS_NS + +#endif +#endif + +/* ERROR/WARNING messages: + +E: Illegal ... command + +UNDOCUMENTED + +E: CMAP atoms %d %d %d %d %d missing on proc %d at step %ld + +UNDOCUMENTED + +E: Invalid CMAP crossterm_type + +UNDOCUMENTED + +E: Cannot open fix cmap file %s + +UNDOCUMENTED + +E: CMAP: atan2 function cannot take 2 zero arguments + +UNDOCUMENTED + +E: Invalid read data header line for fix cmap + +UNDOCUMENTED + +E: Incorrect %s format in data file + +UNDOCUMENTED + +E: Too many CMAP crossterms for one atom + +UNDOCUMENTED + +*/ From 85d4312703e562c2bf64aa29709f4f8ebc8e4942 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Fri, 4 Mar 2022 13:52:04 -0700 Subject: [PATCH 072/585] add pitorsions to tinker2lmp.py --- tools/tinker/data.py | 13 ++- tools/tinker/tinker2lmp.py | 221 ++++++++++++++++++++++++++++++------- 2 files changed, 189 insertions(+), 45 deletions(-) diff --git a/tools/tinker/data.py b/tools/tinker/data.py index 2932eee8e3..b8c0e284a1 100644 --- a/tools/tinker/data.py +++ b/tools/tinker/data.py @@ -351,20 +351,25 @@ class data: # data file keywords, both header and main sections hkeywords = ["atoms","ellipsoids","lines","triangles","bodies", - "bonds","angles","dihedrals","impropers", + "bonds","angles","dihedrals","impropers","pitorsions", "atom types","bond types","angle types","dihedral types", - "improper types","xlo xhi","ylo yhi","zlo zhi","xy xz yz"] + "improper types","pitorsion types", + "xlo xhi","ylo yhi","zlo zhi","xy xz yz"] skeywords = [["Masses","atom types"], ["Atoms","atoms"],["Ellipsoids","ellipsoids"], ["Lines","lines"],["Triangles","triangles"],["Bodies","bodies"], ["Bonds","bonds"], - ["Angles","angles"],["Dihedrals","dihedrals"], - ["Impropers","impropers"],["Velocities","atoms"], + ["Angles","angles"], + ["Dihedrals","dihedrals"], + ["Impropers","impropers"], + ["PiTorsions","pitorsions"], + ["Velocities","atoms"], ["Pair Coeffs","atom types"], ["Bond Coeffs","bond types"],["Angle Coeffs","angle types"], ["Dihedral Coeffs","dihedral types"], ["Improper Coeffs","improper types"], + ["PiTorsion Coeffs","pitorsion types"], ["BondBond Coeffs","angle types"], ["BondAngle Coeffs","angle types"], ["MiddleBondTorsion Coeffs","dihedral types"], diff --git a/tools/tinker/tinker2lmp.py b/tools/tinker/tinker2lmp.py index d0233ba8d4..d0535d377e 100644 --- a/tools/tinker/tinker2lmp.py +++ b/tools/tinker/tinker2lmp.py @@ -13,8 +13,6 @@ # Author: Steve Plimpton import sys,os,math -path = os.environ["LAMMPS_PYTHON_TOOLS"] -sys.path.append(path) from data import data BIG = 1.0e20 @@ -107,10 +105,21 @@ class PRMfile: self.angleparams = self.angles() self.bondangleparams = self.bondangles() self.torsionparams = self.torsions() - self.ureyparams = self.ureybonds() self.opbendparams = self.opbend() + self.ureyparams = self.ureybonds() + self.pitorsionparams = self.pitorsions() self.ntypes = len(self.masses) + # find a section in the PRM file + + def find_section(self,txt): + txt = "## %s ##" % txt + for iline,line in enumerate(self.lines): + if txt in line: return iline + return -1 + + # scalar params + def force_field_definition(self): iline = self.find_section("Force Field Definition") iline += 3 @@ -125,7 +134,9 @@ class PRMfile: elif words[0] == "angle-pentic": self.angle_pentic = float(words[1]) elif words[0] == "angle-sextic": self.angle_sextic = float(words[1]) iline += 1 - + + # atom classes and masses + def peratom(self): classes = [] masses = [] @@ -143,6 +154,8 @@ class PRMfile: iline += 1 return classes,masses + # polarization groups + def polarize(self): polgroup = [] iline = self.find_section("Dipole Polarizability Parameters") @@ -297,33 +310,7 @@ class PRMfile: iline += 1 return params - # convert PRMfile params to LAMMPS bond_style class2 bond params - # coeffs for K2,K3 = 0.0 since Urey-Bradley is simple harmonic - - def ureybonds(self): - params = [] - iline = self.find_section("Urey-Bradley Parameters") - if iline < 0: return params - iline += 3 - - while iline < self.nlines: - words = self.lines[iline].split() - if len(words): - if words[0].startswith("###########"): break - if words[0] == "ureybrad": - class1 = int(words[1]) - class2 = int(words[2]) - class3 = int(words[3]) - value1 = float(words[4]) - value2 = float(words[5]) - lmp1 = value1 - lmp2 = value2 - - params.append((class1,class2,class3,lmp1,lmp2,0.0,0.0)) - iline += 1 - return params - - # Dihedral interactions + # dihedral interactions def torsions(self): params = [] @@ -363,7 +350,7 @@ class PRMfile: iline += 1 return params - # Improper or out-of-plane bend interactions + # improper or out-of-plane bend interactions def opbend(self): params = [] @@ -385,11 +372,53 @@ class PRMfile: iline += 1 return params - def find_section(self,txt): - txt = "## %s ##" % txt - for iline,line in enumerate(self.lines): - if txt in line: return iline - return -1 + # convert PRMfile params to LAMMPS bond_style class2 bond params + # coeffs for K2,K3 = 0.0 since Urey-Bradley is simple harmonic + + def ureybonds(self): + params = [] + iline = self.find_section("Urey-Bradley Parameters") + if iline < 0: return params + iline += 3 + + while iline < self.nlines: + words = self.lines[iline].split() + if len(words): + if words[0].startswith("###########"): break + if words[0] == "ureybrad": + class1 = int(words[1]) + class2 = int(words[2]) + class3 = int(words[3]) + value1 = float(words[4]) + value2 = float(words[5]) + lmp1 = value1 + lmp2 = value2 + + params.append((class1,class2,class3,lmp1,lmp2,0.0,0.0)) + iline += 1 + return params + + # Pi Torsion params, will be read from data file by fix pitorsion + + def pitorsions(self): + params = [] + iline = self.find_section("Pi-Torsion Parameters") + if iline < 0: return params + iline += 3 + + while iline < self.nlines: + words = self.lines[iline].split() + if len(words): + if words[0].startswith("###########"): break + if words[0] == "pitors": + class1 = int(words[1]) + class2 = int(words[2]) + value1 = float(words[3]) + lmp1 = value1 + + params.append((class1,class2,lmp1)) + iline += 1 + return params # ---------------------------------------- # main program @@ -639,6 +668,49 @@ for atom1,atom2,atom3 in alist: elif (c3,c2,c1) in ubdict: ublist.append((atom3,atom2,atom1)) +# ---------------------------------------- +# create list of 6-body Pi-Torsion interactions +# ---------------------------------------- + +# create ptorslist = list of 6-body interactions +# based on central bond, each bond atom is bonded to exactly 2 other atoms +# avoid double counting by requiring atom1 < atom2 +# NOTE: need more info on how to order the 6 atoms for Tinker to compute on + +type = xyz.type +classes = prm.classes +bonds = xyz.bonds + +pitorsionlist = [] + +for atom1 in id: + for atom2 in bonds[atom1-1]: + if atom1 < atom2: + if len(bonds[atom1-1]) != 3: continue + if len(bonds[atom2-1]) != 3: continue + + if bonds[atom1-1][0] == atom2: + atom3 = bonds[atom1-1][1] + atom4 = bonds[atom1-1][2] + elif bonds[atom1-1][1] == atom2: + atom3 = bonds[atom1-1][0] + atom4 = bonds[atom1-1][2] + elif bonds[atom1-1][2] == atom2: + atom3 = bonds[atom1-1][0] + atom4 = bonds[atom1-1][1] + + if bonds[atom2-1][0] == atom1: + atom5 = bonds[atom2-1][1] + atom6 = bonds[atom2-1][2] + elif bonds[atom2-1][1] == atom1: + atom5 = bonds[atom2-1][0] + atom6 = bonds[atom2-1][2] + elif bonds[atom2-1][2] == atom1: + atom5 = bonds[atom2-1][0] + atom6 = bonds[atom2-1][1] + + pitorsionlist.append((atom3,atom4,atom1,atom2,atom5,atom6)) + # ---------------------------------------- # create lists of bond/angle/dihedral/improper types # ---------------------------------------- @@ -954,7 +1026,53 @@ for atom1,atom2,atom3,atom4 in olist: # replace original olist with reduced version olist = olist_reduced + +# generate pitorsiontype = LAMMPS type of each pitorsion +# generate pitorsionparams = LAMMPS params for each pitorsion type +# flags[i] = which LAMMPS pitorsion type (1-N) the Ith Tinker PRM file ptors is +# 0 = none +# convert prm.pitorsionparams to a dictionary for efficient searching +# key = (class1,class2) +# value = (M,params) where M is index into prm.pitorsionparams + +id = xyz.id +type = xyz.type +classes = prm.classes + +pitdict = {} +for m,params in enumerate(prm.pitorsionparams): + pitdict[(params[0],params[1])] = (m,params) + +flags = len(prm.pitorsionparams)*[0] +pitorsiontype = [] +pitorsionparams = [] + +for tmp1,tmp2,atom1,atom2,tmp3,tmp4 in pitorsionlist: + type1 = type[atom1-1] + type2 = type[atom2-1] + c1 = classes[type1-1] + c2 = classes[type2-1] + + if (c1,c2) in pitdict: m,params = pitdict[(c1,c2)] + elif (c2,c1) in pitdict: m,params = pitdict[(c2,c1)] + else: + # NOTE: probably this PiT should be deleted from enumeration list + # similar to olist for impropers above + # IMPORTANT: look at other errors and messages t2lmp.py is producing + error("PiTorsion not found: %d %d: %d %d" % (atom1,atom2,c1,c2)) + pitorsiontype.append(0) + continue + if not flags[m]: + v1 = params[2:] + pitorsionparams.append(v1) + flags[m] = len(pitorsionparams) + pitorsiontype.append(flags[m]) + +print "PRM pitor param",len(prm.pitorsionparams) +print "PiTor list",len(pitorsionlist) +print "Flags",flags + # ---------------------------------------- # assign each atom to a Tinker group # NOTE: doing this inside LAMMPS now @@ -1009,6 +1127,7 @@ nbonds = len(blist) nangles = len(alist) ndihedrals = len(dlist) nimpropers = len(olist) +npitorsions = len(pitorsionlist) # data file header values @@ -1119,6 +1238,24 @@ if nimpropers: lines.append(line+'\n') d.sections["Impropers"] = lines +if npitorsions: + d.headers["pitorsions"] = len(pitorsionlist) + d.headers["pitorsion types"] = len(pitorsionparams) + + lines = [] + for i,one in enumerate(pitorsionparams): + strone = [str(single) for single in one] + line = "%d %s" % (i+1,' '.join(strone)) + lines.append(line+'\n') + d.sections["PiTorsion Coeffs"] = lines + + lines = [] + for i,one in enumerate(pitorsionlist): + line = "%d %d %d %d %d %d %d %d" % \ + (i+1,pitorsiontype[i],one[0],one[1],one[2],one[3],one[4],one[5]) + lines.append(line+'\n') + d.sections["PiTorsions"] = lines + d.write(datafile) # print stats to screen @@ -1129,11 +1266,13 @@ print "Tinker XYZ types =",len(tink2lmp) print "Tinker PRM types =",prm.ntypes #print "Tinker groups =",ngroups print "Nmol =",nmol -print "Nbonds =",len(blist) -print "Nangles =",len(alist) -print "Ndihedrals =",len(dlist) -print "Nimpropers =",len(olist) +print "Nbonds =",nbonds +print "Nangles =",nangles +print "Ndihedrals =",ndihedrals +print "Nimpropers =",nimpropers +print "Npitorsions =",npitorsions print "Nbondtypes =",len(bparams) print "Nangletypes =",len(aparams) print "Ndihedraltypes =",len(dparams) print "Nimpropertypes =",len(oparams) +print "Npitorsiontypes =",len(pitorsionparams) From 60b7da84dbf95e54a332f0ca9b4f0dbdaa3c3950 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Fri, 4 Mar 2022 13:56:55 -0700 Subject: [PATCH 073/585] add comment of something to check --- tools/tinker/tinker2lmp.py | 4 ++++ 1 file changed, 4 insertions(+) diff --git a/tools/tinker/tinker2lmp.py b/tools/tinker/tinker2lmp.py index d0535d377e..6d867673f9 100644 --- a/tools/tinker/tinker2lmp.py +++ b/tools/tinker/tinker2lmp.py @@ -600,6 +600,10 @@ for atom2 in id: # additional loop over bonds of atom3 # avoid double counting the reverse dihedral by use of ddict dictionary +# NOTE: could just avoid double count by "if atom1 < atom4" as in bond, angle ? +# gives different list, but is it still identical ? +# would have to check 2 data files, write comparison Py script + id = xyz.id type = xyz.type bonds = xyz.bonds From 5c10b621b32503565510ba4093ad328f9e0d676c Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Mon, 7 Mar 2022 10:31:09 -0700 Subject: [PATCH 074/585] add pitorion logic to new fix --- examples/amoeba/in.ubiquitin | 5 +- src/AMOEBA/fix_pitorsion.cpp | 623 ++++++++++++++++++----------------- src/AMOEBA/fix_pitorsion.h | 79 ++--- 3 files changed, 354 insertions(+), 353 deletions(-) diff --git a/examples/amoeba/in.ubiquitin b/examples/amoeba/in.ubiquitin index 66ab107f79..36a455c149 100644 --- a/examples/amoeba/in.ubiquitin +++ b/examples/amoeba/in.ubiquitin @@ -14,11 +14,14 @@ improper_style amoeba # per-atom properties required by AMOEBA or HIPPO fix amtype all property/atom i_amtype ghost yes +fix pitorsion all pitorsion + fix extra all property/atom & i_amgroup i_ired i_xaxis i_yaxis i_zaxis d_pval ghost yes fix extra2 all property/atom i_polaxe -read_data data.ubiquitin fix amtype NULL "Tinker Types" +read_data data.ubiquitin fix amtype NULL "Tinker Types" & + fix pitorsion pitorsions PiTorsions pair_style amoeba pair_coeff * * amoeba_ubiquitin.prm amoeba_ubiquitin.key diff --git a/src/AMOEBA/fix_pitorsion.cpp b/src/AMOEBA/fix_pitorsion.cpp index 15f2a8f79d..ec8f0d71be 100644 --- a/src/AMOEBA/fix_pitorsion.cpp +++ b/src/AMOEBA/fix_pitorsion.cpp @@ -12,25 +12,6 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -/* ---------------------------------------------------------------------- - Contributing authors: - Xiaohu Hu, CMB/ORNL (hux2@ornl.gov) - David Hyde-Volpe, Tigran Abramyan, and Robert A. Latour (Clemson University) - Chris Lorenz (Kings College-London) - - Implementation of the CHARMM CMAP; adds an extra energy term for the - peptide backbone dihedrals. The tools/ch2lmp/charmm2lammps.pl - conversion script, which generates an extra section in the LAMMPS data - file, is needed in order to generate the info used by this fix style. - - References: - - MacKerell et al., J. Am. Chem. Soc. 126(2004):698-699. - - MacKerell et al., J. Comput. Chem. 25(2004):1400-1415. -------------------------------------------------------------------------- */ - -// read_data data.ubiquitin fix pitorsion pitorsions PiTorsions - - #include "fix_pitorsion.h" #include @@ -50,21 +31,21 @@ using namespace LAMMPS_NS; using namespace FixConst; using namespace MathConst; -#define MAXLINE 256 -#define LISTDELTA 10000 +#define PITORSIONMAX 6 +#define LISTDELTA 8196 #define LB_FACTOR 1.5 /* ---------------------------------------------------------------------- */ FixPiTorsion::FixPiTorsion(LAMMPS *lmp, int narg, char **arg) : Fix(lmp, narg, arg), - crosstermlist(nullptr), num_crossterm(nullptr), crossterm_type(nullptr), - crossterm_atom1(nullptr), crossterm_atom2(nullptr), crossterm_atom3(nullptr), - crossterm_atom4(nullptr), crossterm_atom5(nullptr), - g_axis(nullptr), cmapgrid(nullptr), d1cmapgrid(nullptr), d2cmapgrid(nullptr), - d12cmapgrid(nullptr) + pitorsion_list(nullptr), num_pitorsion(nullptr), pitorsion_type(nullptr), + pitorsion_atom1(nullptr), pitorsion_atom2(nullptr), pitorsion_atom3(nullptr), + pitorsion_atom4(nullptr), pitorsion_atom5(nullptr), pitorsion_atom6(nullptr) { - if (narg != 4) error->all(FLERR,"Illegal fix cmap command"); + if (narg != 3) error->all(FLERR,"Illegal fix pitorsion command"); + + // settings for this fix restart_global = 1; restart_peratom = 1; @@ -85,70 +66,59 @@ FixPiTorsion::FixPiTorsion(LAMMPS *lmp, int narg, char **arg) : MPI_Comm_rank(world,&me); MPI_Comm_size(world,&nprocs); - // allocate memory for CMAP data - - memory->create(g_axis,CMAPDIM,"cmap:g_axis"); - memory->create(cmapgrid,6,CMAPDIM,CMAPDIM,"cmap:grid"); - memory->create(d1cmapgrid,6,CMAPDIM,CMAPDIM,"cmap:d1grid"); - memory->create(d2cmapgrid,6,CMAPDIM,CMAPDIM,"cmap:d2grid"); - memory->create(d12cmapgrid,6,CMAPDIM,CMAPDIM,"cmap:d12grid"); - - // read and setup CMAP data - - read_grid_map(arg[3]); - // perform initial allocation of atom-based arrays - // register with Atom class - num_crossterm = nullptr; - crossterm_type = nullptr; - crossterm_atom1 = nullptr; - crossterm_atom2 = nullptr; - crossterm_atom3 = nullptr; - crossterm_atom4 = nullptr; - crossterm_atom5 = nullptr; + num_pitorsion = nullptr; + pitorsion_type = nullptr; + pitorsion_atom1 = nullptr; + pitorsion_atom2 = nullptr; + pitorsion_atom3 = nullptr; + pitorsion_atom4 = nullptr; + pitorsion_atom5 = nullptr; + pitorsion_atom6 = nullptr; + + // register with Atom class nmax_previous = 0; grow_arrays(atom->nmax); atom->add_callback(Atom::GROW); atom->add_callback(Atom::RESTART); - // local list of crossterms + // list of all pitorsions to compute on this proc - ncmap = 0; - maxcrossterm = 0; - crosstermlist = nullptr; + npitorsion_list = 0; + max_pitorsion_list = 0; + pitorsion_list = nullptr; } /* --------------------------------------------------------------------- */ -FixCMAP::~FixCMAP() +FixPiTorsion::~FixPiTorsion() { // unregister callbacks to this fix from Atom class atom->delete_callback(id,Atom::GROW); atom->delete_callback(id,Atom::RESTART); - memory->destroy(g_axis); - memory->destroy(cmapgrid); - memory->destroy(d1cmapgrid); - memory->destroy(d2cmapgrid); - memory->destroy(d12cmapgrid); + // per-atom data - memory->destroy(crosstermlist); + memory->destroy(num_pitorsion); + memory->destroy(pitorsion_type); + memory->destroy(pitorsion_atom1); + memory->destroy(pitorsion_atom2); + memory->destroy(pitorsion_atom3); + memory->destroy(pitorsion_atom4); + memory->destroy(pitorsion_atom5); + memory->destroy(pitorsion_atom6); - memory->destroy(num_crossterm); - memory->destroy(crossterm_type); - memory->destroy(crossterm_atom1); - memory->destroy(crossterm_atom2); - memory->destroy(crossterm_atom3); - memory->destroy(crossterm_atom4); - memory->destroy(crossterm_atom5); + // compute list + + memory->destroy(pitorsion_list); } /* ---------------------------------------------------------------------- */ -int FixCMAP::setmask() +int FixPiTorsion::setmask() { int mask = 0; mask |= PRE_NEIGHBOR; @@ -161,28 +131,8 @@ int FixCMAP::setmask() /* ---------------------------------------------------------------------- */ -void FixCMAP::init() +void FixPiTorsion::init() { - int i; - double angle; - - i = 0; - angle = -180.0; - while (angle < 180.0) { - g_axis[i] = angle; - angle += CMAPDX; - i++; - } - - // pre-compute the derivatives of the maps - - for (i = 0; i < 6; i++) - set_map_derivatives(cmapgrid[i],d1cmapgrid[i],d2cmapgrid[i],d12cmapgrid[i]); - - // define newton_bond here in case restart file was read (not data file) - - newton_bond = force->newton_bond; - if (utils::strmatch(update->integrate_style,"^respa")) { ilevel_respa = ((Respa *) update->integrate)->nlevels-1; if (respa_level >= 0) ilevel_respa = MIN(respa_level,ilevel_respa); @@ -191,7 +141,7 @@ void FixCMAP::init() /* --------------------------------------------------------------------- */ -void FixCMAP::setup(int vflag) +void FixPiTorsion::setup(int vflag) { pre_neighbor(); @@ -206,82 +156,88 @@ void FixCMAP::setup(int vflag) /* --------------------------------------------------------------------- */ -void FixCMAP::setup_pre_neighbor() +void FixPiTorsion::setup_pre_neighbor() { pre_neighbor(); } /* --------------------------------------------------------------------- */ -void FixCMAP::setup_pre_reverse(int eflag, int vflag) +void FixPiTorsion::setup_pre_reverse(int eflag, int vflag) { pre_reverse(eflag,vflag); } /* --------------------------------------------------------------------- */ -void FixCMAP::min_setup(int vflag) +void FixPiTorsion::min_setup(int vflag) { pre_neighbor(); post_force(vflag); } /* ---------------------------------------------------------------------- - store local neighbor list as if newton_bond = OFF, even if actually ON + store local neighbor list for newton_bond ON ------------------------------------------------------------------------- */ -void FixCMAP::pre_neighbor() +void FixPiTorsion::pre_neighbor() { - int i,m,atom1,atom2,atom3,atom4,atom5; + int i,m,atom1,atom2,atom3,atom4,atom5,atom6; - // guesstimate initial length of local crossterm list - // if ncmap was not set (due to read_restart, no read_data), + // guesstimate initial length of local pitorsion list + // if npitorsion_global was not set (due to read_restart, no read_data), // then list will grow by LISTDELTA chunks - if (maxcrossterm == 0) { - if (nprocs == 1) maxcrossterm = ncmap; - else maxcrossterm = static_cast (LB_FACTOR*ncmap/nprocs); - memory->create(crosstermlist,maxcrossterm,6,"cmap:crosstermlist"); + if (max_pitorsion_list == 0) { + if (nprocs == 1) max_pitorsion_list = npitorsion_global; + else max_pitorsion_list = + static_cast (LB_FACTOR*npitorsion_global/nprocs); + memory->create(pitorsion_list,max_pitorsion_list,7, + "pitorsion:pitorsion_list"); } int nlocal = atom->nlocal; - - ncrosstermlist = 0; + pitorsion_list = 0; for (i = 0; i < nlocal; i++) { - for (m = 0; m < num_crossterm[i]; m++) { - atom1 = atom->map(crossterm_atom1[i][m]); - atom2 = atom->map(crossterm_atom2[i][m]); - atom3 = atom->map(crossterm_atom3[i][m]); - atom4 = atom->map(crossterm_atom4[i][m]); - atom5 = atom->map(crossterm_atom5[i][m]); + for (m = 0; m < num_pitorsion[i]; m++) { + atom1 = atom->map(pitorsion_atom1[i][m]); + atom2 = atom->map(pitorsion_atom2[i][m]); + atom3 = atom->map(pitorsion_atom3[i][m]); + atom4 = atom->map(pitorsion_atom4[i][m]); + atom5 = atom->map(pitorsion_atom5[i][m]); + atom6 = atom->map(pitorsion_atom6[i][m]); if (atom1 == -1 || atom2 == -1 || atom3 == -1 || atom4 == -1 || atom5 == -1) - error->one(FLERR,"CMAP atoms {} {} {} {} {} missing on " - "proc {} at step {}", - crossterm_atom1[i][m],crossterm_atom2[i][m], - crossterm_atom3[i][m],crossterm_atom4[i][m], - crossterm_atom5[i][m],me,update->ntimestep); + error->one(FLERR,"PiTorsion atoms {} {} {} {} {} {} missing on " + "proc {} at step {}", + pitorsion_atom1[i][m],pitorsion_atom2[i][m], + pitorsion_atom3[i][m],pitorsion_atom4[i][m], + pitorsion_atom5[i][m],pitorsion_atom6[i][m], + me,update->ntimestep); atom1 = domain->closest_image(i,atom1); atom2 = domain->closest_image(i,atom2); atom3 = domain->closest_image(i,atom3); atom4 = domain->closest_image(i,atom4); atom5 = domain->closest_image(i,atom5); + atom6 = domain->closest_image(i,atom6); if (i <= atom1 && i <= atom2 && i <= atom3 && - i <= atom4 && i <= atom5) { - if (ncrosstermlist == maxcrossterm) { - maxcrossterm += LISTDELTA; - memory->grow(crosstermlist,maxcrossterm,6,"cmap:crosstermlist"); + i <= atom4 && i <= atom5 && i <= atom6) { + if (npitorsion_list == max_pitorsion_list) { + max_pitorsion_list += LISTDELTA; + memory->grow(pitorsion_list,max_pitorsion_list,7, + "pitorsion:pitorsion_list"); } - crosstermlist[ncrosstermlist][0] = atom1; - crosstermlist[ncrosstermlist][1] = atom2; - crosstermlist[ncrosstermlist][2] = atom3; - crosstermlist[ncrosstermlist][3] = atom4; - crosstermlist[ncrosstermlist][4] = atom5; - crosstermlist[ncrosstermlist][5] = crossterm_type[i][m]; - ncrosstermlist++; + pitorsion_list[npitorsion_list][0] = atom1; + pitorsion_list[npitorsion_list][1] = atom2; + pitorsion_list[npitorsion_list][2] = atom3; + pitorsion_list[npitorsion_list][3] = atom4; + pitorsion_list[npitorsion_list][4] = atom5; + pitorsion_list[npitorsion_list][5] = atom6; + pitorsion_list[npitorsion_list][6] = pitorsion_type[i][m]; + npitorsion_list++; } } } @@ -291,7 +247,7 @@ void FixCMAP::pre_neighbor() store eflag, so can use it in post_force to tally per-atom energies ------------------------------------------------------------------------- */ -void FixCMAP::pre_reverse(int eflag, int /*vflag*/) +void FixPiTorsion::pre_reverse(int eflag, int /*vflag*/) { eflag_caller = eflag; } @@ -300,18 +256,62 @@ void FixCMAP::pre_reverse(int eflag, int /*vflag*/) compute PiTorsion terms as if newton_bond = OFF, even if actually ON ------------------------------------------------------------------------- */ -void FixCMAP::post_force(int vflag) +void FixPiTorsion::post_force(int vflag) { + int ia,ib,ic,id,ie,ig,ptype; + double e,dedphi; + double xt,yt,zt,rt2; + double xu,yu,zu,ru2; + double xtu,ytu,ztu; + double rdc,rtru; + double v2,c2,s2; + double phi2,dphi2; + double sine,cosine; + double sine2,cosine2; + double xia,yia,zia; + double xib,yib,zib; + double xic,yic,zic; + double xid,yid,zid; + double xie,yie,zie; + double xig,yig,zig; + double xip,yip,zip; + double xiq,yiq,ziq; + double xad,yad,zad; + double xbd,ybd,zbd; + double xec,yec,zec; + double xgc,ygc,zgc; + double xcp,ycp,zcp; + double xdc,ydc,zdc; + double xqd,yqd,zqd; + double xdp,ydp,zdp; + double xqc,yqc,zqc; + double dedxt,dedyt,dedzt; + double dedxu,dedyu,dedzu; + double dedxia,dedyia,dedzia; + double dedxib,dedyib,dedzib; + double dedxic,dedyic,dedzic; + double dedxid,dedyid,dedzid; + double dedxie,dedyie,dedzie; + double dedxig,dedyig,dedzig; + double dedxip,dedyip,dedzip; + double dedxiq,dedyiq,dedziq; + double vxterm,vyterm,vzterm; + double vxx,vyy,vzz; + double vyx,vzx,vzy; + double **x = atom->x; double **f = atom->f; - for (int n = 0; n < npitors; n++) { - ia = ipit[n][0]; - ib = ipit[n][1]; - ic = ipit[n][2]; - id = ipit[n][3]; - ie = ipit[n][4]; - ig = ipit[n][5]; + epitorsion = 0.0; + + for (int n = 0; n < npitorsion_list; n++) { + ia = pitorsion_list[n][0]; + ib = pitorsion_list[n][0]; + ic = pitorsion_list[n][0]; + id = pitorsion_list[n][0]; + ie = pitorsion_list[n][0]; + ig = pitorsion_list[n][0]; + ptype = pitorsion_list[n][6]; // compute the value of the pi-system torsion angle @@ -384,7 +384,7 @@ void FixCMAP::post_force(int vflag) // set the pi-system torsion parameters for this angle - v2 = kpit(i); + v2 = kpit[ptype]; c2 = -1.0; s2 = 0.0; @@ -397,6 +397,8 @@ void FixCMAP::post_force(int vflag) // calculate pi-system torsion energy and master chain rule term + // NOTE: is ptornunit 1.0 ? + double ptorunit = 1.0; e = ptorunit * v2 * phi2; dedphi = ptorunit * v2 * dphi2; @@ -453,7 +455,7 @@ void FixCMAP::post_force(int vflag) // increment the total pi-system torsion energy and gradient - ept += e; + epitorsion += e; f[ia][0] += dedxia; f[ia][1] += dedyia; @@ -497,26 +499,26 @@ void FixCMAP::post_force(int vflag) /* ---------------------------------------------------------------------- */ -void FixCMAP::post_force_respa(int vflag, int ilevel, int /*iloop*/) +void FixPiTorsion::post_force_respa(int vflag, int ilevel, int /*iloop*/) { if (ilevel == ilevel_respa) post_force(vflag); } /* ---------------------------------------------------------------------- */ -void FixCMAP::min_post_force(int vflag) +void FixPiTorsion::min_post_force(int vflag) { post_force(vflag); } /* ---------------------------------------------------------------------- - energy of CMAP term + energy of PiTorsion term ------------------------------------------------------------------------- */ -double FixCMAP::compute_scalar() +double FixPiTorsion::compute_scalar() { double all; - MPI_Allreduce(&ecmap,&all,1,MPI_DOUBLE,MPI_SUM,world); + MPI_Allreduce(&epitorsion,&all,1,MPI_DOUBLE,MPI_SUM,world); return all; } @@ -526,10 +528,10 @@ double FixCMAP::compute_scalar() // ---------------------------------------------------------------------- // ---------------------------------------------------------------------- -void FixCMAP::read_data_header(char *line) +void FixPiTorsion::read_data_header(char *line) { if (strstr(line,"pitorsions")) { - sscanf(line,BIGINT_FORMAT,&ncmap); + sscanf(line,BIGINT_FORMAT,&npitorsion_global); } else error->all(FLERR,"Invalid read data header line for fix pitorsion"); // didn't set in constructor because this fix could be defined @@ -541,14 +543,14 @@ void FixCMAP::read_data_header(char *line) /* ---------------------------------------------------------------------- unpack N lines in buf from section of data file labeled by keyword id_offset is applied to atomID fields if multiple data files are read - store CMAP interactions as if newton_bond = OFF, even if actually ON + store PiTorsion interactions as if newton_bond = OFF, even if actually ON ------------------------------------------------------------------------- */ -void FixCMAP::read_data_section(char *keyword, int n, char *buf, - tagint id_offset) +void FixPiTorsion::read_data_section(char *keyword, int n, char *buf, + tagint id_offset) { int m,tmp,itype; - tagint atom1,atom2,atom3,atom4,atom5; + tagint atom1,atom2,atom3,atom4,atom5,atom6; char *next; next = strchr(buf,'\n'); @@ -561,79 +563,98 @@ void FixCMAP::read_data_section(char *keyword, int n, char *buf, // loop over lines of PiTorsions // tokenize the line into values - // add crossterm to one of my atoms, depending on newton_bond + // add PiTorsion to one or more of my atoms, depending on newton_bond for (int i = 0; i < n; i++) { next = strchr(buf,'\n'); *next = '\0'; sscanf(buf,"%d %d " TAGINT_FORMAT " " TAGINT_FORMAT " " TAGINT_FORMAT - " " TAGINT_FORMAT " " TAGINT_FORMAT, - &tmp,&itype,&atom1,&atom2,&atom3,&atom4,&atom5); + " " TAGINT_FORMAT " " TAGINT_FORMAT " " TAGINT_FORMAT, + &tmp,&itype,&atom1,&atom2,&atom3,&atom4,&atom5,&atom6); atom1 += id_offset; atom2 += id_offset; atom3 += id_offset; atom4 += id_offset; atom5 += id_offset; + atom6 += id_offset; if ((m = atom->map(atom1)) >= 0) { - if (num_crossterm[m] == CMAPMAX) - error->one(FLERR,"Too many CMAP crossterms for one atom"); - crossterm_type[m][num_crossterm[m]] = itype; - crossterm_atom1[m][num_crossterm[m]] = atom1; - crossterm_atom2[m][num_crossterm[m]] = atom2; - crossterm_atom3[m][num_crossterm[m]] = atom3; - crossterm_atom4[m][num_crossterm[m]] = atom4; - crossterm_atom5[m][num_crossterm[m]] = atom5; - num_crossterm[m]++; + if (num_pitorsion[m] == PITORSIONMAX) + error->one(FLERR,"Too many PiTorsions for one atom"); + pitorsion_type[m][num_pitorsion[m]] = itype; + pitorsion_atom1[m][num_pitorsion[m]] = atom1; + pitorsion_atom2[m][num_pitorsion[m]] = atom2; + pitorsion_atom3[m][num_pitorsion[m]] = atom3; + pitorsion_atom4[m][num_pitorsion[m]] = atom4; + pitorsion_atom5[m][num_pitorsion[m]] = atom5; + pitorsion_atom6[m][num_pitorsion[m]] = atom6; + num_pitorsion[m]++; } if ((m = atom->map(atom2)) >= 0) { - if (num_crossterm[m] == CMAPMAX) - error->one(FLERR,"Too many CMAP crossterms for one atom"); - crossterm_type[m][num_crossterm[m]] = itype; - crossterm_atom1[m][num_crossterm[m]] = atom1; - crossterm_atom2[m][num_crossterm[m]] = atom2; - crossterm_atom3[m][num_crossterm[m]] = atom3; - crossterm_atom4[m][num_crossterm[m]] = atom4; - crossterm_atom5[m][num_crossterm[m]] = atom5; - num_crossterm[m]++; + if (num_pitorsion[m] == PITORSIONMAX) + error->one(FLERR,"Too many PiTorsions for one atom"); + pitorsion_type[m][num_pitorsion[m]] = itype; + pitorsion_atom1[m][num_pitorsion[m]] = atom1; + pitorsion_atom2[m][num_pitorsion[m]] = atom2; + pitorsion_atom3[m][num_pitorsion[m]] = atom3; + pitorsion_atom4[m][num_pitorsion[m]] = atom4; + pitorsion_atom5[m][num_pitorsion[m]] = atom5; + pitorsion_atom6[m][num_pitorsion[m]] = atom6; + num_pitorsion[m]++; } if ((m = atom->map(atom3)) >= 0) { - if (num_crossterm[m] == CMAPMAX) - error->one(FLERR,"Too many CMAP crossterms for one atom"); - crossterm_type[m][num_crossterm[m]] = itype; - crossterm_atom1[m][num_crossterm[m]] = atom1; - crossterm_atom2[m][num_crossterm[m]] = atom2; - crossterm_atom3[m][num_crossterm[m]] = atom3; - crossterm_atom4[m][num_crossterm[m]] = atom4; - crossterm_atom5[m][num_crossterm[m]] = atom5; - num_crossterm[m]++; + if (num_pitorsion[m] == PITORSIONMAX) + error->one(FLERR,"Too many PiTorsions for one atom"); + pitorsion_type[m][num_pitorsion[m]] = itype; + pitorsion_atom1[m][num_pitorsion[m]] = atom1; + pitorsion_atom2[m][num_pitorsion[m]] = atom2; + pitorsion_atom3[m][num_pitorsion[m]] = atom3; + pitorsion_atom4[m][num_pitorsion[m]] = atom4; + pitorsion_atom5[m][num_pitorsion[m]] = atom5; + pitorsion_atom6[m][num_pitorsion[m]] = atom6; + num_pitorsion[m]++; } if ((m = atom->map(atom4)) >= 0) { - if (num_crossterm[m] == CMAPMAX) - error->one(FLERR,"Too many CMAP crossterms for one atom"); - crossterm_type[m][num_crossterm[m]] = itype; - crossterm_atom1[m][num_crossterm[m]] = atom1; - crossterm_atom2[m][num_crossterm[m]] = atom2; - crossterm_atom3[m][num_crossterm[m]] = atom3; - crossterm_atom4[m][num_crossterm[m]] = atom4; - crossterm_atom5[m][num_crossterm[m]] = atom5; - num_crossterm[m]++; + if (num_pitorsion[m] == PITORSIONMAX) + error->one(FLERR,"Too many PiTorsions for one atom"); + pitorsion_type[m][num_pitorsion[m]] = itype; + pitorsion_atom1[m][num_pitorsion[m]] = atom1; + pitorsion_atom2[m][num_pitorsion[m]] = atom2; + pitorsion_atom3[m][num_pitorsion[m]] = atom3; + pitorsion_atom4[m][num_pitorsion[m]] = atom4; + pitorsion_atom5[m][num_pitorsion[m]] = atom5; + pitorsion_atom6[m][num_pitorsion[m]] = atom6; + num_pitorsion[m]++; } if ((m = atom->map(atom5)) >= 0) { - if (num_crossterm[m] == CMAPMAX) - error->one(FLERR,"Too many CMAP crossterms for one atom"); - crossterm_type[m][num_crossterm[m]] = itype; - crossterm_atom1[m][num_crossterm[m]] = atom1; - crossterm_atom2[m][num_crossterm[m]] = atom2; - crossterm_atom3[m][num_crossterm[m]] = atom3; - crossterm_atom4[m][num_crossterm[m]] = atom4; - crossterm_atom5[m][num_crossterm[m]] = atom5; - num_crossterm[m]++; + if (num_pitorsion[m] == PITORSIONMAX) + error->one(FLERR,"Too many PiTorsions for one atom"); + pitorsion_type[m][num_pitorsion[m]] = itype; + pitorsion_atom1[m][num_pitorsion[m]] = atom1; + pitorsion_atom2[m][num_pitorsion[m]] = atom2; + pitorsion_atom3[m][num_pitorsion[m]] = atom3; + pitorsion_atom4[m][num_pitorsion[m]] = atom4; + pitorsion_atom5[m][num_pitorsion[m]] = atom5; + pitorsion_atom6[m][num_pitorsion[m]] = atom6; + num_pitorsion[m]++; + } + + if ((m = atom->map(atom6)) >= 0) { + if (num_pitorsion[m] == PITORSIONMAX) + error->one(FLERR,"Too many PiTorsions for one atom"); + pitorsion_type[m][num_pitorsion[m]] = itype; + pitorsion_atom1[m][num_pitorsion[m]] = atom1; + pitorsion_atom2[m][num_pitorsion[m]] = atom2; + pitorsion_atom3[m][num_pitorsion[m]] = atom3; + pitorsion_atom4[m][num_pitorsion[m]] = atom4; + pitorsion_atom5[m][num_pitorsion[m]] = atom5; + pitorsion_atom6[m][num_pitorsion[m]] = atom6; + num_pitorsion[m]++; } buf = next + 1; @@ -642,9 +663,9 @@ void FixCMAP::read_data_section(char *keyword, int n, char *buf, /* ---------------------------------------------------------------------- */ -bigint FixCMAP::read_data_skip_lines(char * /*keyword*/) +bigint FixPiTorsion::read_data_skip_lines(char * /*keyword*/) { - return ncmap; + return npitorsion_global; } /* ---------------------------------------------------------------------- @@ -652,20 +673,20 @@ bigint FixCMAP::read_data_skip_lines(char * /*keyword*/) only called by proc 0 ------------------------------------------------------------------------- */ -void FixCMAP::write_data_header(FILE *fp, int /*mth*/) +void FixPiTorsion::write_data_header(FILE *fp, int /*mth*/) { - fprintf(fp,BIGINT_FORMAT " cmap crossterms\n",ncmap); + fprintf(fp,BIGINT_FORMAT " pitorsions\n",npitorsion_global); } /* ---------------------------------------------------------------------- return size I own for Mth data section # of data sections = 1 for this fix - nx = # of crossterms owned by my local atoms - if newton_bond off, atom only owns crossterm if it is atom3 - ny = columns = type + 5 atom IDs + nx = # of PiTorsions owned by my local atoms + if newton_bond off, atom only owns PiTorsion if it is atom3 + ny = columns = type + 6 atom IDs ------------------------------------------------------------------------- */ -void FixCMAP::write_data_section_size(int /*mth*/, int &nx, int &ny) +void FixPiTorsion::write_data_section_size(int /*mth*/, int &nx, int &ny) { int i,m; @@ -674,22 +695,24 @@ void FixCMAP::write_data_section_size(int /*mth*/, int &nx, int &ny) nx = 0; for (i = 0; i < nlocal; i++) - for (m = 0; m < num_crossterm[i]; m++) - if (crossterm_atom3[i][m] == tag[i]) nx++; + for (m = 0; m < num_pitorsion[i]; m++) + if (pitorsion_atom3[i][m] == tag[i]) nx++; - ny = 6; + // NOTE: should be a check for newton bond? + + ny = 7; } /* ---------------------------------------------------------------------- pack values for Mth data section into 2d buf - buf allocated by caller as owned crossterms by 6 + buf allocated by caller as owned PiTorsions by 7 ------------------------------------------------------------------------- */ -void FixCMAP::write_data_section_pack(int /*mth*/, double **buf) +void FixPiTorsion::write_data_section_pack(int /*mth*/, double **buf) { int i,m; - // 1st column = CMAP type + // 1st column = PiTorsion type // 2nd-6th columns = 5 atom IDs tagint *tag = atom->tag; @@ -697,14 +720,16 @@ void FixCMAP::write_data_section_pack(int /*mth*/, double **buf) int n = 0; for (i = 0; i < nlocal; i++) { - for (m = 0; m < num_crossterm[i]; m++) { - if (crossterm_atom3[i][m] != tag[i]) continue; - buf[n][0] = ubuf(crossterm_type[i][m]).d; - buf[n][1] = ubuf(crossterm_atom1[i][m]).d; - buf[n][2] = ubuf(crossterm_atom2[i][m]).d; - buf[n][3] = ubuf(crossterm_atom3[i][m]).d; - buf[n][4] = ubuf(crossterm_atom4[i][m]).d; - buf[n][5] = ubuf(crossterm_atom5[i][m]).d; + for (m = 0; m < num_pitorsion[i]; m++) { + // NOTE: check for newton bond on/off ? + if (pitorsion_atom3[i][m] != tag[i]) continue; + buf[n][0] = ubuf(pitorsion_type[i][m]).d; + buf[n][1] = ubuf(pitorsion_atom1[i][m]).d; + buf[n][2] = ubuf(pitorsion_atom2[i][m]).d; + buf[n][3] = ubuf(pitorsion_atom3[i][m]).d; + buf[n][4] = ubuf(pitorsion_atom4[i][m]).d; + buf[n][5] = ubuf(pitorsion_atom5[i][m]).d; + buf[n][6] = ubuf(pitorsion_atom6[i][m]).d; n++; } } @@ -716,9 +741,9 @@ void FixCMAP::write_data_section_pack(int /*mth*/, double **buf) only called by proc 0 ------------------------------------------------------------------------- */ -void FixCMAP::write_data_section_keyword(int /*mth*/, FILE *fp) +void FixPiTorsion::write_data_section_keyword(int /*mth*/, FILE *fp) { - fprintf(fp,"\nCMAP\n\n"); + fprintf(fp,"\nPiTorsion\n\n"); } /* ---------------------------------------------------------------------- @@ -728,7 +753,7 @@ void FixCMAP::write_data_section_keyword(int /*mth*/, FILE *fp) only called by proc 0 ------------------------------------------------------------------------- */ -void FixCMAP::write_data_section(int /*mth*/, FILE *fp, +void FixPiTorsion::write_data_section(int /*mth*/, FILE *fp, int n, double **buf, int index) { for (int i = 0; i < n; i++) @@ -749,12 +774,12 @@ void FixCMAP::write_data_section(int /*mth*/, FILE *fp, pack entire state of Fix into one write ------------------------------------------------------------------------- */ -void FixCMAP::write_restart(FILE *fp) +void FixPiTorsion::write_restart(FILE *fp) { if (comm->me == 0) { int size = sizeof(bigint); fwrite(&size,sizeof(int),1,fp); - fwrite(&ncmap,sizeof(bigint),1,fp); + fwrite(&npitorsion_global,sizeof(bigint),1,fp); } } @@ -762,27 +787,27 @@ void FixCMAP::write_restart(FILE *fp) use state info from restart file to restart the Fix ------------------------------------------------------------------------- */ -void FixCMAP::restart(char *buf) +void FixPiTorsion::restart(char *buf) { - ncmap = *((bigint *) buf); + npitorsion_global = *((bigint *) buf); } /* ---------------------------------------------------------------------- pack values in local atom-based arrays for restart file ------------------------------------------------------------------------- */ -int FixCMAP::pack_restart(int i, double *buf) +int FixPiTorsion::pack_restart(int i, double *buf) { int n = 1; - for (int m = 0; m < num_crossterm[i]; m++) { - buf[n++] = ubuf(MAX(crossterm_type[i][m],-crossterm_type[i][m])).d; - buf[n++] = ubuf(crossterm_atom1[i][m]).d; - buf[n++] = ubuf(crossterm_atom2[i][m]).d; - buf[n++] = ubuf(crossterm_atom3[i][m]).d; - buf[n++] = ubuf(crossterm_atom4[i][m]).d; - buf[n++] = ubuf(crossterm_atom5[i][m]).d; + for (int m = 0; m < num_pitorsion[i]; m++) { + buf[n++] = ubuf(MAX(pitorsion_type[i][m],-pitorsion_type[i][m])).d; + buf[n++] = ubuf(pitorsion_atom1[i][m]).d; + buf[n++] = ubuf(pitorsion_atom2[i][m]).d; + buf[n++] = ubuf(pitorsion_atom3[i][m]).d; + buf[n++] = ubuf(pitorsion_atom4[i][m]).d; + buf[n++] = ubuf(pitorsion_atom5[i][m]).d; + buf[n++] = ubuf(pitorsion_atom6[i][m]).d; } - // pack buf[0] this way because other fixes unpack it buf[0] = n; return n; @@ -792,7 +817,7 @@ int FixCMAP::pack_restart(int i, double *buf) unpack values from atom->extra array to restart the fix ------------------------------------------------------------------------- */ -void FixCMAP::unpack_restart(int nlocal, int nth) +void FixPiTorsion::unpack_restart(int nlocal, int nth) { double **extra = atom->extra; @@ -803,15 +828,16 @@ void FixCMAP::unpack_restart(int nlocal, int nth) for (int i = 0; i < nth; i++) n += static_cast (extra[nlocal][n]); int count = static_cast (extra[nlocal][n++]); - num_crossterm[nlocal] = (count-1)/6; + num_pitorsion[nlocal] = (count-1)/7; - for (int m = 0; m < num_crossterm[nlocal]; m++) { - crossterm_type[nlocal][m] = (int) ubuf(extra[nlocal][n++]).i; - crossterm_atom1[nlocal][m] = (tagint) ubuf(extra[nlocal][n++]).i; - crossterm_atom2[nlocal][m] = (tagint) ubuf(extra[nlocal][n++]).i; - crossterm_atom3[nlocal][m] = (tagint) ubuf(extra[nlocal][n++]).i; - crossterm_atom4[nlocal][m] = (tagint) ubuf(extra[nlocal][n++]).i; - crossterm_atom5[nlocal][m] = (tagint) ubuf(extra[nlocal][n++]).i; + for (int m = 0; m < num_pitorsion[nlocal]; m++) { + pitorsion_type[nlocal][m] = (int) ubuf(extra[nlocal][n++]).i; + pitorsion_atom1[nlocal][m] = (tagint) ubuf(extra[nlocal][n++]).i; + pitorsion_atom2[nlocal][m] = (tagint) ubuf(extra[nlocal][n++]).i; + pitorsion_atom3[nlocal][m] = (tagint) ubuf(extra[nlocal][n++]).i; + pitorsion_atom4[nlocal][m] = (tagint) ubuf(extra[nlocal][n++]).i; + pitorsion_atom5[nlocal][m] = (tagint) ubuf(extra[nlocal][n++]).i; + pitorsion_atom6[nlocal][m] = (tagint) ubuf(extra[nlocal][n++]).i; } } @@ -819,44 +845,46 @@ void FixCMAP::unpack_restart(int nlocal, int nth) maxsize of any atom's restart data ------------------------------------------------------------------------- */ -int FixCMAP::maxsize_restart() +int FixPiTorsion::maxsize_restart() { - return 1 + CMAPMAX*6; + return 1 + PITORSIONMAX*6; } /* ---------------------------------------------------------------------- size of atom nlocal's restart data ------------------------------------------------------------------------- */ -int FixCMAP::size_restart(int nlocal) +int FixPiTorsion::size_restart(int nlocal) { - return 1 + num_crossterm[nlocal]*6; + return 1 + num_pitorsion[nlocal]*7; } /* ---------------------------------------------------------------------- - allocate atom-based array + allocate atom-based arrays ------------------------------------------------------------------------- */ -void FixCMAP::grow_arrays(int nmax) +void FixPiTorsion::grow_arrays(int nmax) { - num_crossterm = memory->grow(num_crossterm,nmax,"cmap:num_crossterm"); - crossterm_type = memory->grow(crossterm_type,nmax,CMAPMAX, - "cmap:crossterm_type"); - crossterm_atom1 = memory->grow(crossterm_atom1,nmax,CMAPMAX, - "cmap:crossterm_atom1"); - crossterm_atom2 = memory->grow(crossterm_atom2,nmax,CMAPMAX, - "cmap:crossterm_atom2"); - crossterm_atom3 = memory->grow(crossterm_atom3,nmax,CMAPMAX, - "cmap:crossterm_atom3"); - crossterm_atom4 = memory->grow(crossterm_atom4,nmax,CMAPMAX, - "cmap:crossterm_atom4"); - crossterm_atom5 = memory->grow(crossterm_atom5,nmax,CMAPMAX, - "cmap:crossterm_atom5"); + num_pitorsion = memory->grow(num_pitorsion,nmax,"pitorsion:num_pitorsion"); + pitorsion_type = memory->grow(pitorsion_type,nmax,PITORSIONMAX, + "pitorsion:pitorsion_type"); + pitorsion_atom1 = memory->grow(pitorsion_atom1,nmax,PITORSIONMAX, + "pitorsion:pitorsion_atom1"); + pitorsion_atom2 = memory->grow(pitorsion_atom2,nmax,PITORSIONMAX, + "pitorsion:pitorsion_atom2"); + pitorsion_atom3 = memory->grow(pitorsion_atom3,nmax,PITORSIONMAX, + "pitorsion:pitorsion_atom3"); + pitorsion_atom4 = memory->grow(pitorsion_atom4,nmax,PITORSIONMAX, + "pitorsion:pitorsion_atom4"); + pitorsion_atom5 = memory->grow(pitorsion_atom5,nmax,PITORSIONMAX, + "pitorsion:pitorsion_atom5"); + pitorsion_atom6 = memory->grow(pitorsion_atom6,nmax,PITORSIONMAX, + "pitorsion:pitorsion_atom6"); - // must initialize num_crossterm to 0 for added atoms + // initialize num_pitorion to 0 for added atoms // may never be set for some atoms when data file is read - for (int i = nmax_previous; i < nmax; i++) num_crossterm[i] = 0; + for (int i = nmax_previous; i < nmax; i++) num_pitorsion[i] = 0; nmax_previous = nmax; } @@ -864,17 +892,18 @@ void FixCMAP::grow_arrays(int nmax) copy values within local atom-based array ------------------------------------------------------------------------- */ -void FixCMAP::copy_arrays(int i, int j, int /*delflag*/) +void FixPiTorsion::copy_arrays(int i, int j, int /*delflag*/) { - num_crossterm[j] = num_crossterm[i]; + num_pitorsion[j] = num_pitorsion[i]; - for (int k = 0; k < num_crossterm[j]; k++) { - crossterm_type[j][k] = crossterm_type[i][k]; - crossterm_atom1[j][k] = crossterm_atom1[i][k]; - crossterm_atom2[j][k] = crossterm_atom2[i][k]; - crossterm_atom3[j][k] = crossterm_atom3[i][k]; - crossterm_atom4[j][k] = crossterm_atom4[i][k]; - crossterm_atom5[j][k] = crossterm_atom5[i][k]; + for (int k = 0; k < num_pitorsion[j]; k++) { + pitorsion_type[j][k] = pitorsion_type[i][k]; + pitorsion_atom1[j][k] = pitorsion_atom1[i][k]; + pitorsion_atom2[j][k] = pitorsion_atom2[i][k]; + pitorsion_atom3[j][k] = pitorsion_atom3[i][k]; + pitorsion_atom4[j][k] = pitorsion_atom4[i][k]; + pitorsion_atom5[j][k] = pitorsion_atom5[i][k]; + pitorsion_atom6[j][k] = pitorsion_atom6[i][k]; } } @@ -882,26 +911,27 @@ void FixCMAP::copy_arrays(int i, int j, int /*delflag*/) initialize one atom's array values, called when atom is created ------------------------------------------------------------------------- */ -void FixCMAP::set_arrays(int i) +void FixPiTorsion::set_arrays(int i) { - num_crossterm[i] = 0; + num_pitorsion[i] = 0; } /* ---------------------------------------------------------------------- pack values in local atom-based array for exchange with another proc ------------------------------------------------------------------------- */ -int FixCMAP::pack_exchange(int i, double *buf) +int FixPiTorsion::pack_exchange(int i, double *buf) { int n = 0; - buf[n++] = ubuf(num_crossterm[i]).d; - for (int m = 0; m < num_crossterm[i]; m++) { - buf[n++] = ubuf(crossterm_type[i][m]).d; - buf[n++] = ubuf(crossterm_atom1[i][m]).d; - buf[n++] = ubuf(crossterm_atom2[i][m]).d; - buf[n++] = ubuf(crossterm_atom3[i][m]).d; - buf[n++] = ubuf(crossterm_atom4[i][m]).d; - buf[n++] = ubuf(crossterm_atom5[i][m]).d; + buf[n++] = ubuf(num_pitorsion[i]).d; + for (int m = 0; m < num_pitorsion[i]; m++) { + buf[n++] = ubuf(pitorsion_type[i][m]).d; + buf[n++] = ubuf(pitorsion_atom1[i][m]).d; + buf[n++] = ubuf(pitorsion_atom2[i][m]).d; + buf[n++] = ubuf(pitorsion_atom3[i][m]).d; + buf[n++] = ubuf(pitorsion_atom4[i][m]).d; + buf[n++] = ubuf(pitorsion_atom5[i][m]).d; + buf[n++] = ubuf(pitorsion_atom6[i][m]).d; } return n; } @@ -910,17 +940,18 @@ int FixCMAP::pack_exchange(int i, double *buf) unpack values in local atom-based array from exchange with another proc ------------------------------------------------------------------------- */ -int FixCMAP::unpack_exchange(int nlocal, double *buf) +int FixPiTorsion::unpack_exchange(int nlocal, double *buf) { int n = 0; - num_crossterm[nlocal] = (int) ubuf(buf[n++]).i; - for (int m = 0; m < num_crossterm[nlocal]; m++) { - crossterm_type[nlocal][m] = (int) ubuf(buf[n++]).i; - crossterm_atom1[nlocal][m] = (tagint) ubuf(buf[n++]).i; - crossterm_atom2[nlocal][m] = (tagint) ubuf(buf[n++]).i; - crossterm_atom3[nlocal][m] = (tagint) ubuf(buf[n++]).i; - crossterm_atom4[nlocal][m] = (tagint) ubuf(buf[n++]).i; - crossterm_atom5[nlocal][m] = (tagint) ubuf(buf[n++]).i; + num_pitorsion[nlocal] = (int) ubuf(buf[n++]).i; + for (int m = 0; m < num_pitorsion[nlocal]; m++) { + pitorsion_type[nlocal][m] = (int) ubuf(buf[n++]).i; + pitorsion_atom1[nlocal][m] = (tagint) ubuf(buf[n++]).i; + pitorsion_atom2[nlocal][m] = (tagint) ubuf(buf[n++]).i; + pitorsion_atom3[nlocal][m] = (tagint) ubuf(buf[n++]).i; + pitorsion_atom4[nlocal][m] = (tagint) ubuf(buf[n++]).i; + pitorsion_atom5[nlocal][m] = (tagint) ubuf(buf[n++]).i; + pitorsion_atom6[nlocal][m] = (tagint) ubuf(buf[n++]).i; } return n; } @@ -929,12 +960,12 @@ int FixCMAP::unpack_exchange(int nlocal, double *buf) memory usage of local atom-based arrays ------------------------------------------------------------------------- */ -double FixCMAP::memory_usage() +double FixPiTorsion::memory_usage() { int nmax = atom->nmax; - double bytes = (double)nmax * sizeof(int); // num_crossterm - bytes += (double)nmax*CMAPMAX * sizeof(int); // crossterm_type - bytes += (double)5*nmax*CMAPMAX * sizeof(int); // crossterm_atom 12345 - bytes += (double)maxcrossterm*6 * sizeof(int); // crosstermlist + double bytes = (double)nmax * sizeof(int); // num_pitorsion + bytes += (double)nmax*PITORSIONMAX * sizeof(int); // pitorsion_type + bytes += (double)6*nmax*PITORSIONMAX * sizeof(int); // pitorsion_atom 123456 + bytes += (double)7*max_pitorsion_list * sizeof(int); // pitorsion_list return bytes; } diff --git a/src/AMOEBA/fix_pitorsion.h b/src/AMOEBA/fix_pitorsion.h index ae70f9faad..efb448a408 100644 --- a/src/AMOEBA/fix_pitorsion.h +++ b/src/AMOEBA/fix_pitorsion.h @@ -13,20 +13,20 @@ #ifdef FIX_CLASS // clang-format off -FixStyle(cmap,FixCMAP); +FixStyle(pitorsion,FixPiTorsion); // clang-format on #else -#ifndef LMP_FIX_CMAP_H -#define LMP_FIX_CMAP_H +#ifndef LMP_FIX_PITORSION_H +#define LMP_FIX_PITORSION_H #include "fix.h" namespace LAMMPS_NS { -class FixCMAP : public Fix { +class FixPiTorsion : public Fix { public: - FixCMAP(class LAMMPS *, int, char **); - ~FixCMAP(); + FixPiTorsion(class LAMMPS *, int, char **); + ~FixPiTorsion(); int setmask(); void init(); void setup(int); @@ -67,61 +67,28 @@ class FixCMAP : public Fix { private: int nprocs, me; int newton_bond, eflag_caller; - int ctype, ilevel_respa; - int ncrosstermtypes, crossterm_per_atom, maxcrossterm; - int ncrosstermlist; - bigint ncmap; + int ilevel_respa; + bigint npitorsion_global; + double epitorsion; - int **crosstermlist; + double *kpit; + + // per-atom data for pitorsions stored with each owned atom + + int *num_pitorsion; + int **pitorsion_type; + tagint **pitorsion_atom1, **pitorsion_atom2, **pitorsion_atom3; + tagint **pitorsion_atom4, **pitorsion_atom5, **pitorsion_atom6; + + // previous max atoms on this proc before grow() is called int nmax_previous; - int *num_crossterm; - int **crossterm_type; - tagint **crossterm_atom1, **crossterm_atom2, **crossterm_atom3; - tagint **crossterm_atom4, **crossterm_atom5; - double E, dEdPhi, dEdPsi; - double ecmap; - double fcmap[4], cij[4][4]; - double *g_axis; + // list of all pitorsions to compute on this proc - // CMAP grid points obtained from external file - - double ***cmapgrid; - - // partial derivatives and cross-derivatives of the grid data - - double ***d1cmapgrid, ***d2cmapgrid, ***d12cmapgrid; - - // read map grid data - - void read_grid_map(char *); - - // read in CMAP cross terms from LAMMPS data file - - void read_cmap_data(int, char *); - - // pre-compute the partial and cross-derivatives of map grid points - - void set_map_derivatives(double **, double **, double **, double **); - - // cubic spline interpolation functions for derivatives of map grid points - - void spline(double *, double *, int); - void spl_interpolate(double, double *, double *, double &, double &); - - // calculate dihedral angles - - double dihedral_angle_atan2(double, double, double, double, double, double, double, double, - double, double); - - // calculate bicubic interpolation coefficient matrix c_ij - - void bc_coeff(double *, double *, double *, double *); - - // perform bicubic interpolation at point of interest - - void bc_interpol(double, double, int, int, double *, double *, double *, double *); + int npitorsion_list; + int max_pitorsion_list; + int **pitorsion_list; }; } // namespace LAMMPS_NS From 7087dfc0193c93bdd26114e7382b0953ce6f25cb Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Mon, 7 Mar 2022 11:02:44 -0700 Subject: [PATCH 075/585] bug fix for enumerating Urey-Bradley bonds --- examples/amoeba/data.ubiquitin | 5670 ++++++++++++++++---------------- examples/amoeba/in.ubiquitin | 7 +- tools/tinker/tinker2lmp.py | 4 +- 3 files changed, 2841 insertions(+), 2840 deletions(-) diff --git a/examples/amoeba/data.ubiquitin b/examples/amoeba/data.ubiquitin index 4151ae36a8..361291cdd4 100644 --- a/examples/amoeba/data.ubiquitin +++ b/examples/amoeba/data.ubiquitin @@ -16673,2841 +16673,2841 @@ Bonds 6906 48 9732 9734 6907 48 9735 9736 6908 48 9735 9737 -6909 49 74 74 -6910 49 74 74 -6911 49 74 74 -6912 49 74 74 -6913 49 74 74 -6914 49 74 74 -6915 49 74 74 -6916 49 74 74 -6917 49 74 74 -6918 49 74 74 -6919 49 74 74 -6920 49 74 74 -6921 49 74 74 -6922 49 74 74 -6923 49 74 74 -6924 49 74 74 -6925 49 74 74 -6926 49 74 74 -6927 49 74 74 -6928 49 74 74 -6929 49 74 74 -6930 49 74 74 -6931 49 74 74 -6932 49 74 74 -6933 49 74 74 -6934 49 74 74 -6935 49 74 74 -6936 49 74 74 -6937 49 74 74 -6938 49 74 74 -6939 49 74 74 -6940 49 74 74 -6941 49 74 74 -6942 49 74 74 -6943 49 74 74 -6944 49 74 74 -6945 49 74 74 -6946 49 74 74 -6947 49 74 74 -6948 49 74 74 -6949 49 74 74 -6950 49 74 74 -6951 49 74 74 -6952 49 74 74 -6953 49 74 74 -6954 49 74 74 -6955 49 74 74 -6956 49 74 74 -6957 49 74 74 -6958 49 74 74 -6959 49 74 74 -6960 49 74 74 -6961 49 74 74 -6962 49 74 74 -6963 49 74 74 -6964 49 74 74 -6965 49 74 74 -6966 49 74 74 -6967 49 74 74 -6968 49 74 74 -6969 49 74 74 -6970 49 74 74 -6971 49 74 74 -6972 49 74 74 -6973 49 74 74 -6974 49 74 74 -6975 49 74 74 -6976 49 74 74 -6977 49 74 74 -6978 49 74 74 -6979 49 74 74 -6980 49 74 74 -6981 49 74 74 -6982 49 74 74 -6983 49 74 74 -6984 49 74 74 -6985 49 74 74 -6986 49 74 74 -6987 49 74 74 -6988 49 74 74 -6989 49 74 74 -6990 49 74 74 -6991 49 74 74 -6992 49 74 74 -6993 49 74 74 -6994 49 74 74 -6995 49 74 74 -6996 49 74 74 -6997 49 74 74 -6998 49 74 74 -6999 49 74 74 -7000 49 74 74 -7001 49 74 74 -7002 49 74 74 -7003 49 74 74 -7004 49 74 74 -7005 49 74 74 -7006 49 74 74 -7007 49 74 74 -7008 49 74 74 -7009 49 74 74 -7010 49 74 74 -7011 49 74 74 -7012 49 74 74 -7013 49 74 74 -7014 49 74 74 -7015 49 74 74 -7016 49 74 74 -7017 49 74 74 -7018 49 74 74 -7019 49 74 74 -7020 49 74 74 -7021 49 74 74 -7022 49 74 74 -7023 49 74 74 -7024 49 74 74 -7025 49 74 74 -7026 49 74 74 -7027 49 74 74 -7028 49 74 74 -7029 49 74 74 -7030 49 74 74 -7031 49 74 74 -7032 49 74 74 -7033 49 74 74 -7034 49 74 74 -7035 49 74 74 -7036 49 74 74 -7037 49 74 74 -7038 49 74 74 -7039 49 74 74 -7040 49 74 74 -7041 49 74 74 -7042 49 74 74 -7043 49 74 74 -7044 49 74 74 -7045 49 74 74 -7046 49 74 74 -7047 49 74 74 -7048 49 74 74 -7049 49 74 74 -7050 49 74 74 -7051 49 74 74 -7052 49 74 74 -7053 49 74 74 -7054 49 74 74 -7055 49 74 74 -7056 49 74 74 -7057 49 74 74 -7058 49 74 74 -7059 49 74 74 -7060 49 74 74 -7061 49 74 74 -7062 49 74 74 -7063 49 74 74 -7064 49 74 74 -7065 49 74 74 -7066 49 74 74 -7067 49 74 74 -7068 49 74 74 -7069 49 74 74 -7070 49 74 74 -7071 49 74 74 -7072 49 74 74 -7073 49 74 74 -7074 49 74 74 -7075 49 74 74 -7076 49 74 74 -7077 49 74 74 -7078 49 74 74 -7079 49 74 74 -7080 49 74 74 -7081 49 74 74 -7082 49 74 74 -7083 49 74 74 -7084 49 74 74 -7085 49 74 74 -7086 49 74 74 -7087 49 74 74 -7088 49 74 74 -7089 49 74 74 -7090 49 74 74 -7091 49 74 74 -7092 49 74 74 -7093 49 74 74 -7094 49 74 74 -7095 49 74 74 -7096 49 74 74 -7097 49 74 74 -7098 49 74 74 -7099 49 74 74 -7100 49 74 74 -7101 49 74 74 -7102 49 74 74 -7103 49 74 74 -7104 49 74 74 -7105 49 74 74 -7106 49 74 74 -7107 49 74 74 -7108 49 74 74 -7109 49 74 74 -7110 49 74 74 -7111 49 74 74 -7112 49 74 74 -7113 49 74 74 -7114 49 74 74 -7115 49 74 74 -7116 49 74 74 -7117 49 74 74 -7118 49 74 74 -7119 49 74 74 -7120 49 74 74 -7121 49 74 74 -7122 49 74 74 -7123 49 74 74 -7124 49 74 74 -7125 49 74 74 -7126 49 74 74 -7127 49 74 74 -7128 49 74 74 -7129 49 74 74 -7130 49 74 74 -7131 49 74 74 -7132 49 74 74 -7133 49 74 74 -7134 49 74 74 -7135 49 74 74 -7136 49 74 74 -7137 49 74 74 -7138 49 74 74 -7139 49 74 74 -7140 49 74 74 -7141 49 74 74 -7142 49 74 74 -7143 49 74 74 -7144 49 74 74 -7145 49 74 74 -7146 49 74 74 -7147 49 74 74 -7148 49 74 74 -7149 49 74 74 -7150 49 74 74 -7151 49 74 74 -7152 49 74 74 -7153 49 74 74 -7154 49 74 74 -7155 49 74 74 -7156 49 74 74 -7157 49 74 74 -7158 49 74 74 -7159 49 74 74 -7160 49 74 74 -7161 49 74 74 -7162 49 74 74 -7163 49 74 74 -7164 49 74 74 -7165 49 74 74 -7166 49 74 74 -7167 49 74 74 -7168 49 74 74 -7169 49 74 74 -7170 49 74 74 -7171 49 74 74 -7172 49 74 74 -7173 49 74 74 -7174 49 74 74 -7175 49 74 74 -7176 49 74 74 -7177 49 74 74 -7178 49 74 74 -7179 49 74 74 -7180 49 74 74 -7181 49 74 74 -7182 49 74 74 -7183 49 74 74 -7184 49 74 74 -7185 49 74 74 -7186 49 74 74 -7187 49 74 74 -7188 49 74 74 -7189 49 74 74 -7190 49 74 74 -7191 49 74 74 -7192 49 74 74 -7193 49 74 74 -7194 49 74 74 -7195 49 74 74 -7196 49 74 74 -7197 49 74 74 -7198 49 74 74 -7199 49 74 74 -7200 49 74 74 -7201 49 74 74 -7202 49 74 74 -7203 49 74 74 -7204 49 74 74 -7205 49 74 74 -7206 49 74 74 -7207 49 74 74 -7208 49 74 74 -7209 49 74 74 -7210 49 74 74 -7211 49 74 74 -7212 49 74 74 -7213 49 74 74 -7214 49 74 74 -7215 49 74 74 -7216 49 74 74 -7217 49 74 74 -7218 49 74 74 -7219 49 74 74 -7220 49 74 74 -7221 49 74 74 -7222 49 74 74 -7223 49 74 74 -7224 49 74 74 -7225 49 74 74 -7226 49 74 74 -7227 49 74 74 -7228 49 74 74 -7229 49 74 74 -7230 49 74 74 -7231 49 74 74 -7232 49 74 74 -7233 49 74 74 -7234 49 74 74 -7235 49 74 74 -7236 49 74 74 -7237 49 74 74 -7238 49 74 74 -7239 49 74 74 -7240 49 74 74 -7241 49 74 74 -7242 49 74 74 -7243 49 74 74 -7244 49 74 74 -7245 49 74 74 -7246 49 74 74 -7247 49 74 74 -7248 49 74 74 -7249 49 74 74 -7250 49 74 74 -7251 49 74 74 -7252 49 74 74 -7253 49 74 74 -7254 49 74 74 -7255 49 74 74 -7256 49 74 74 -7257 49 74 74 -7258 49 74 74 -7259 49 74 74 -7260 49 74 74 -7261 49 74 74 -7262 49 74 74 -7263 49 74 74 -7264 49 74 74 -7265 49 74 74 -7266 49 74 74 -7267 49 74 74 -7268 49 74 74 -7269 49 74 74 -7270 49 74 74 -7271 49 74 74 -7272 49 74 74 -7273 49 74 74 -7274 49 74 74 -7275 49 74 74 -7276 49 74 74 -7277 49 74 74 -7278 49 74 74 -7279 49 74 74 -7280 49 74 74 -7281 49 74 74 -7282 49 74 74 -7283 49 74 74 -7284 49 74 74 -7285 49 74 74 -7286 49 74 74 -7287 49 74 74 -7288 49 74 74 -7289 49 74 74 -7290 49 74 74 -7291 49 74 74 -7292 49 74 74 -7293 49 74 74 -7294 49 74 74 -7295 49 74 74 -7296 49 74 74 -7297 49 74 74 -7298 49 74 74 -7299 49 74 74 -7300 49 74 74 -7301 49 74 74 -7302 49 74 74 -7303 49 74 74 -7304 49 74 74 -7305 49 74 74 -7306 49 74 74 -7307 49 74 74 -7308 49 74 74 -7309 49 74 74 -7310 49 74 74 -7311 49 74 74 -7312 49 74 74 -7313 49 74 74 -7314 49 74 74 -7315 49 74 74 -7316 49 74 74 -7317 49 74 74 -7318 49 74 74 -7319 49 74 74 -7320 49 74 74 -7321 49 74 74 -7322 49 74 74 -7323 49 74 74 -7324 49 74 74 -7325 49 74 74 -7326 49 74 74 -7327 49 74 74 -7328 49 74 74 -7329 49 74 74 -7330 49 74 74 -7331 49 74 74 -7332 49 74 74 -7333 49 74 74 -7334 49 74 74 -7335 49 74 74 -7336 49 74 74 -7337 49 74 74 -7338 49 74 74 -7339 49 74 74 -7340 49 74 74 -7341 49 74 74 -7342 49 74 74 -7343 49 74 74 -7344 49 74 74 -7345 49 74 74 -7346 49 74 74 -7347 49 74 74 -7348 49 74 74 -7349 49 74 74 -7350 49 74 74 -7351 49 74 74 -7352 49 74 74 -7353 49 74 74 -7354 49 74 74 -7355 49 74 74 -7356 49 74 74 -7357 49 74 74 -7358 49 74 74 -7359 49 74 74 -7360 49 74 74 -7361 49 74 74 -7362 49 74 74 -7363 49 74 74 -7364 49 74 74 -7365 49 74 74 -7366 49 74 74 -7367 49 74 74 -7368 49 74 74 -7369 49 74 74 -7370 49 74 74 -7371 49 74 74 -7372 49 74 74 -7373 49 74 74 -7374 49 74 74 -7375 49 74 74 -7376 49 74 74 -7377 49 74 74 -7378 49 74 74 -7379 49 74 74 -7380 49 74 74 -7381 49 74 74 -7382 49 74 74 -7383 49 74 74 -7384 49 74 74 -7385 49 74 74 -7386 49 74 74 -7387 49 74 74 -7388 49 74 74 -7389 49 74 74 -7390 49 74 74 -7391 49 74 74 -7392 49 74 74 -7393 49 74 74 -7394 49 74 74 -7395 49 74 74 -7396 49 74 74 -7397 49 74 74 -7398 49 74 74 -7399 49 74 74 -7400 49 74 74 -7401 49 74 74 -7402 49 74 74 -7403 49 74 74 -7404 49 74 74 -7405 49 74 74 -7406 49 74 74 -7407 49 74 74 -7408 49 74 74 -7409 49 74 74 -7410 49 74 74 -7411 49 74 74 -7412 49 74 74 -7413 49 74 74 -7414 49 74 74 -7415 49 74 74 -7416 49 74 74 -7417 49 74 74 -7418 49 74 74 -7419 49 74 74 -7420 49 74 74 -7421 49 74 74 -7422 49 74 74 -7423 49 74 74 -7424 49 74 74 -7425 49 74 74 -7426 49 74 74 -7427 49 74 74 -7428 49 74 74 -7429 49 74 74 -7430 49 74 74 -7431 49 74 74 -7432 49 74 74 -7433 49 74 74 -7434 49 74 74 -7435 49 74 74 -7436 49 74 74 -7437 49 74 74 -7438 49 74 74 -7439 49 74 74 -7440 49 74 74 -7441 49 74 74 -7442 49 74 74 -7443 49 74 74 -7444 49 74 74 -7445 49 74 74 -7446 49 74 74 -7447 49 74 74 -7448 49 74 74 -7449 49 74 74 -7450 49 74 74 -7451 49 74 74 -7452 49 74 74 -7453 49 74 74 -7454 49 74 74 -7455 49 74 74 -7456 49 74 74 -7457 49 74 74 -7458 49 74 74 -7459 49 74 74 -7460 49 74 74 -7461 49 74 74 -7462 49 74 74 -7463 49 74 74 -7464 49 74 74 -7465 49 74 74 -7466 49 74 74 -7467 49 74 74 -7468 49 74 74 -7469 49 74 74 -7470 49 74 74 -7471 49 74 74 -7472 49 74 74 -7473 49 74 74 -7474 49 74 74 -7475 49 74 74 -7476 49 74 74 -7477 49 74 74 -7478 49 74 74 -7479 49 74 74 -7480 49 74 74 -7481 49 74 74 -7482 49 74 74 -7483 49 74 74 -7484 49 74 74 -7485 49 74 74 -7486 49 74 74 -7487 49 74 74 -7488 49 74 74 -7489 49 74 74 -7490 49 74 74 -7491 49 74 74 -7492 49 74 74 -7493 49 74 74 -7494 49 74 74 -7495 49 74 74 -7496 49 74 74 -7497 49 74 74 -7498 49 74 74 -7499 49 74 74 -7500 49 74 74 -7501 49 74 74 -7502 49 74 74 -7503 49 74 74 -7504 49 74 74 -7505 49 74 74 -7506 49 74 74 -7507 49 74 74 -7508 49 74 74 -7509 49 74 74 -7510 49 74 74 -7511 49 74 74 -7512 49 74 74 -7513 49 74 74 -7514 49 74 74 -7515 49 74 74 -7516 49 74 74 -7517 49 74 74 -7518 49 74 74 -7519 49 74 74 -7520 49 74 74 -7521 49 74 74 -7522 49 74 74 -7523 49 74 74 -7524 49 74 74 -7525 49 74 74 -7526 49 74 74 -7527 49 74 74 -7528 49 74 74 -7529 49 74 74 -7530 49 74 74 -7531 49 74 74 -7532 49 74 74 -7533 49 74 74 -7534 49 74 74 -7535 49 74 74 -7536 49 74 74 -7537 49 74 74 -7538 49 74 74 -7539 49 74 74 -7540 49 74 74 -7541 49 74 74 -7542 49 74 74 -7543 49 74 74 -7544 49 74 74 -7545 49 74 74 -7546 49 74 74 -7547 49 74 74 -7548 49 74 74 -7549 49 74 74 -7550 49 74 74 -7551 49 74 74 -7552 49 74 74 -7553 49 74 74 -7554 49 74 74 -7555 49 74 74 -7556 49 74 74 -7557 49 74 74 -7558 49 74 74 -7559 49 74 74 -7560 49 74 74 -7561 49 74 74 -7562 49 74 74 -7563 49 74 74 -7564 49 74 74 -7565 49 74 74 -7566 49 74 74 -7567 49 74 74 -7568 49 74 74 -7569 49 74 74 -7570 49 74 74 -7571 49 74 74 -7572 49 74 74 -7573 49 74 74 -7574 49 74 74 -7575 49 74 74 -7576 49 74 74 -7577 49 74 74 -7578 49 74 74 -7579 49 74 74 -7580 49 74 74 -7581 49 74 74 -7582 49 74 74 -7583 49 74 74 -7584 49 74 74 -7585 49 74 74 -7586 49 74 74 -7587 49 74 74 -7588 49 74 74 -7589 49 74 74 -7590 49 74 74 -7591 49 74 74 -7592 49 74 74 -7593 49 74 74 -7594 49 74 74 -7595 49 74 74 -7596 49 74 74 -7597 49 74 74 -7598 49 74 74 -7599 49 74 74 -7600 49 74 74 -7601 49 74 74 -7602 49 74 74 -7603 49 74 74 -7604 49 74 74 -7605 49 74 74 -7606 49 74 74 -7607 49 74 74 -7608 49 74 74 -7609 49 74 74 -7610 49 74 74 -7611 49 74 74 -7612 49 74 74 -7613 49 74 74 -7614 49 74 74 -7615 49 74 74 -7616 49 74 74 -7617 49 74 74 -7618 49 74 74 -7619 49 74 74 -7620 49 74 74 -7621 49 74 74 -7622 49 74 74 -7623 49 74 74 -7624 49 74 74 -7625 49 74 74 -7626 49 74 74 -7627 49 74 74 -7628 49 74 74 -7629 49 74 74 -7630 49 74 74 -7631 49 74 74 -7632 49 74 74 -7633 49 74 74 -7634 49 74 74 -7635 49 74 74 -7636 49 74 74 -7637 49 74 74 -7638 49 74 74 -7639 49 74 74 -7640 49 74 74 -7641 49 74 74 -7642 49 74 74 -7643 49 74 74 -7644 49 74 74 -7645 49 74 74 -7646 49 74 74 -7647 49 74 74 -7648 49 74 74 -7649 49 74 74 -7650 49 74 74 -7651 49 74 74 -7652 49 74 74 -7653 49 74 74 -7654 49 74 74 -7655 49 74 74 -7656 49 74 74 -7657 49 74 74 -7658 49 74 74 -7659 49 74 74 -7660 49 74 74 -7661 49 74 74 -7662 49 74 74 -7663 49 74 74 -7664 49 74 74 -7665 49 74 74 -7666 49 74 74 -7667 49 74 74 -7668 49 74 74 -7669 49 74 74 -7670 49 74 74 -7671 49 74 74 -7672 49 74 74 -7673 49 74 74 -7674 49 74 74 -7675 49 74 74 -7676 49 74 74 -7677 49 74 74 -7678 49 74 74 -7679 49 74 74 -7680 49 74 74 -7681 49 74 74 -7682 49 74 74 -7683 49 74 74 -7684 49 74 74 -7685 49 74 74 -7686 49 74 74 -7687 49 74 74 -7688 49 74 74 -7689 49 74 74 -7690 49 74 74 -7691 49 74 74 -7692 49 74 74 -7693 49 74 74 -7694 49 74 74 -7695 49 74 74 -7696 49 74 74 -7697 49 74 74 -7698 49 74 74 -7699 49 74 74 -7700 49 74 74 -7701 49 74 74 -7702 49 74 74 -7703 49 74 74 -7704 49 74 74 -7705 49 74 74 -7706 49 74 74 -7707 49 74 74 -7708 49 74 74 -7709 49 74 74 -7710 49 74 74 -7711 49 74 74 -7712 49 74 74 -7713 49 74 74 -7714 49 74 74 -7715 49 74 74 -7716 49 74 74 -7717 49 74 74 -7718 49 74 74 -7719 49 74 74 -7720 49 74 74 -7721 49 74 74 -7722 49 74 74 -7723 49 74 74 -7724 49 74 74 -7725 49 74 74 -7726 49 74 74 -7727 49 74 74 -7728 49 74 74 -7729 49 74 74 -7730 49 74 74 -7731 49 74 74 -7732 49 74 74 -7733 49 74 74 -7734 49 74 74 -7735 49 74 74 -7736 49 74 74 -7737 49 74 74 -7738 49 74 74 -7739 49 74 74 -7740 49 74 74 -7741 49 74 74 -7742 49 74 74 -7743 49 74 74 -7744 49 74 74 -7745 49 74 74 -7746 49 74 74 -7747 49 74 74 -7748 49 74 74 -7749 49 74 74 -7750 49 74 74 -7751 49 74 74 -7752 49 74 74 -7753 49 74 74 -7754 49 74 74 -7755 49 74 74 -7756 49 74 74 -7757 49 74 74 -7758 49 74 74 -7759 49 74 74 -7760 49 74 74 -7761 49 74 74 -7762 49 74 74 -7763 49 74 74 -7764 49 74 74 -7765 49 74 74 -7766 49 74 74 -7767 49 74 74 -7768 49 74 74 -7769 49 74 74 -7770 49 74 74 -7771 49 74 74 -7772 49 74 74 -7773 49 74 74 -7774 49 74 74 -7775 49 74 74 -7776 49 74 74 -7777 49 74 74 -7778 49 74 74 -7779 49 74 74 -7780 49 74 74 -7781 49 74 74 -7782 49 74 74 -7783 49 74 74 -7784 49 74 74 -7785 49 74 74 -7786 49 74 74 -7787 49 74 74 -7788 49 74 74 -7789 49 74 74 -7790 49 74 74 -7791 49 74 74 -7792 49 74 74 -7793 49 74 74 -7794 49 74 74 -7795 49 74 74 -7796 49 74 74 -7797 49 74 74 -7798 49 74 74 -7799 49 74 74 -7800 49 74 74 -7801 49 74 74 -7802 49 74 74 -7803 49 74 74 -7804 49 74 74 -7805 49 74 74 -7806 49 74 74 -7807 49 74 74 -7808 49 74 74 -7809 49 74 74 -7810 49 74 74 -7811 49 74 74 -7812 49 74 74 -7813 49 74 74 -7814 49 74 74 -7815 49 74 74 -7816 49 74 74 -7817 49 74 74 -7818 49 74 74 -7819 49 74 74 -7820 49 74 74 -7821 49 74 74 -7822 49 74 74 -7823 49 74 74 -7824 49 74 74 -7825 49 74 74 -7826 49 74 74 -7827 49 74 74 -7828 49 74 74 -7829 49 74 74 -7830 49 74 74 -7831 49 74 74 -7832 49 74 74 -7833 49 74 74 -7834 49 74 74 -7835 49 74 74 -7836 49 74 74 -7837 49 74 74 -7838 49 74 74 -7839 49 74 74 -7840 49 74 74 -7841 49 74 74 -7842 49 74 74 -7843 49 74 74 -7844 49 74 74 -7845 49 74 74 -7846 49 74 74 -7847 49 74 74 -7848 49 74 74 -7849 49 74 74 -7850 49 74 74 -7851 49 74 74 -7852 49 74 74 -7853 49 74 74 -7854 49 74 74 -7855 49 74 74 -7856 49 74 74 -7857 49 74 74 -7858 49 74 74 -7859 49 74 74 -7860 49 74 74 -7861 49 74 74 -7862 49 74 74 -7863 49 74 74 -7864 49 74 74 -7865 49 74 74 -7866 49 74 74 -7867 49 74 74 -7868 49 74 74 -7869 49 74 74 -7870 49 74 74 -7871 49 74 74 -7872 49 74 74 -7873 49 74 74 -7874 49 74 74 -7875 49 74 74 -7876 49 74 74 -7877 49 74 74 -7878 49 74 74 -7879 49 74 74 -7880 49 74 74 -7881 49 74 74 -7882 49 74 74 -7883 49 74 74 -7884 49 74 74 -7885 49 74 74 -7886 49 74 74 -7887 49 74 74 -7888 49 74 74 -7889 49 74 74 -7890 49 74 74 -7891 49 74 74 -7892 49 74 74 -7893 49 74 74 -7894 49 74 74 -7895 49 74 74 -7896 49 74 74 -7897 49 74 74 -7898 49 74 74 -7899 49 74 74 -7900 49 74 74 -7901 49 74 74 -7902 49 74 74 -7903 49 74 74 -7904 49 74 74 -7905 49 74 74 -7906 49 74 74 -7907 49 74 74 -7908 49 74 74 -7909 49 74 74 -7910 49 74 74 -7911 49 74 74 -7912 49 74 74 -7913 49 74 74 -7914 49 74 74 -7915 49 74 74 -7916 49 74 74 -7917 49 74 74 -7918 49 74 74 -7919 49 74 74 -7920 49 74 74 -7921 49 74 74 -7922 49 74 74 -7923 49 74 74 -7924 49 74 74 -7925 49 74 74 -7926 49 74 74 -7927 49 74 74 -7928 49 74 74 -7929 49 74 74 -7930 49 74 74 -7931 49 74 74 -7932 49 74 74 -7933 49 74 74 -7934 49 74 74 -7935 49 74 74 -7936 49 74 74 -7937 49 74 74 -7938 49 74 74 -7939 49 74 74 -7940 49 74 74 -7941 49 74 74 -7942 49 74 74 -7943 49 74 74 -7944 49 74 74 -7945 49 74 74 -7946 49 74 74 -7947 49 74 74 -7948 49 74 74 -7949 49 74 74 -7950 49 74 74 -7951 49 74 74 -7952 49 74 74 -7953 49 74 74 -7954 49 74 74 -7955 49 74 74 -7956 49 74 74 -7957 49 74 74 -7958 49 74 74 -7959 49 74 74 -7960 49 74 74 -7961 49 74 74 -7962 49 74 74 -7963 49 74 74 -7964 49 74 74 -7965 49 74 74 -7966 49 74 74 -7967 49 74 74 -7968 49 74 74 -7969 49 74 74 -7970 49 74 74 -7971 49 74 74 -7972 49 74 74 -7973 49 74 74 -7974 49 74 74 -7975 49 74 74 -7976 49 74 74 -7977 49 74 74 -7978 49 74 74 -7979 49 74 74 -7980 49 74 74 -7981 49 74 74 -7982 49 74 74 -7983 49 74 74 -7984 49 74 74 -7985 49 74 74 -7986 49 74 74 -7987 49 74 74 -7988 49 74 74 -7989 49 74 74 -7990 49 74 74 -7991 49 74 74 -7992 49 74 74 -7993 49 74 74 -7994 49 74 74 -7995 49 74 74 -7996 49 74 74 -7997 49 74 74 -7998 49 74 74 -7999 49 74 74 -8000 49 74 74 -8001 49 74 74 -8002 49 74 74 -8003 49 74 74 -8004 49 74 74 -8005 49 74 74 -8006 49 74 74 -8007 49 74 74 -8008 49 74 74 -8009 49 74 74 -8010 49 74 74 -8011 49 74 74 -8012 49 74 74 -8013 49 74 74 -8014 49 74 74 -8015 49 74 74 -8016 49 74 74 -8017 49 74 74 -8018 49 74 74 -8019 49 74 74 -8020 49 74 74 -8021 49 74 74 -8022 49 74 74 -8023 49 74 74 -8024 49 74 74 -8025 49 74 74 -8026 49 74 74 -8027 49 74 74 -8028 49 74 74 -8029 49 74 74 -8030 49 74 74 -8031 49 74 74 -8032 49 74 74 -8033 49 74 74 -8034 49 74 74 -8035 49 74 74 -8036 49 74 74 -8037 49 74 74 -8038 49 74 74 -8039 49 74 74 -8040 49 74 74 -8041 49 74 74 -8042 49 74 74 -8043 49 74 74 -8044 49 74 74 -8045 49 74 74 -8046 49 74 74 -8047 49 74 74 -8048 49 74 74 -8049 49 74 74 -8050 49 74 74 -8051 49 74 74 -8052 49 74 74 -8053 49 74 74 -8054 49 74 74 -8055 49 74 74 -8056 49 74 74 -8057 49 74 74 -8058 49 74 74 -8059 49 74 74 -8060 49 74 74 -8061 49 74 74 -8062 49 74 74 -8063 49 74 74 -8064 49 74 74 -8065 49 74 74 -8066 49 74 74 -8067 49 74 74 -8068 49 74 74 -8069 49 74 74 -8070 49 74 74 -8071 49 74 74 -8072 49 74 74 -8073 49 74 74 -8074 49 74 74 -8075 49 74 74 -8076 49 74 74 -8077 49 74 74 -8078 49 74 74 -8079 49 74 74 -8080 49 74 74 -8081 49 74 74 -8082 49 74 74 -8083 49 74 74 -8084 49 74 74 -8085 49 74 74 -8086 49 74 74 -8087 49 74 74 -8088 49 74 74 -8089 49 74 74 -8090 49 74 74 -8091 49 74 74 -8092 49 74 74 -8093 49 74 74 -8094 49 74 74 -8095 49 74 74 -8096 49 74 74 -8097 49 74 74 -8098 49 74 74 -8099 49 74 74 -8100 49 74 74 -8101 49 74 74 -8102 49 74 74 -8103 49 74 74 -8104 49 74 74 -8105 49 74 74 -8106 49 74 74 -8107 49 74 74 -8108 49 74 74 -8109 49 74 74 -8110 49 74 74 -8111 49 74 74 -8112 49 74 74 -8113 49 74 74 -8114 49 74 74 -8115 49 74 74 -8116 49 74 74 -8117 49 74 74 -8118 49 74 74 -8119 49 74 74 -8120 49 74 74 -8121 49 74 74 -8122 49 74 74 -8123 49 74 74 -8124 49 74 74 -8125 49 74 74 -8126 49 74 74 -8127 49 74 74 -8128 49 74 74 -8129 49 74 74 -8130 49 74 74 -8131 49 74 74 -8132 49 74 74 -8133 49 74 74 -8134 49 74 74 -8135 49 74 74 -8136 49 74 74 -8137 49 74 74 -8138 49 74 74 -8139 49 74 74 -8140 49 74 74 -8141 49 74 74 -8142 49 74 74 -8143 49 74 74 -8144 49 74 74 -8145 49 74 74 -8146 49 74 74 -8147 49 74 74 -8148 49 74 74 -8149 49 74 74 -8150 49 74 74 -8151 49 74 74 -8152 49 74 74 -8153 49 74 74 -8154 49 74 74 -8155 49 74 74 -8156 49 74 74 -8157 49 74 74 -8158 49 74 74 -8159 49 74 74 -8160 49 74 74 -8161 49 74 74 -8162 49 74 74 -8163 49 74 74 -8164 49 74 74 -8165 49 74 74 -8166 49 74 74 -8167 49 74 74 -8168 49 74 74 -8169 49 74 74 -8170 49 74 74 -8171 49 74 74 -8172 49 74 74 -8173 49 74 74 -8174 49 74 74 -8175 49 74 74 -8176 49 74 74 -8177 49 74 74 -8178 49 74 74 -8179 49 74 74 -8180 49 74 74 -8181 49 74 74 -8182 49 74 74 -8183 49 74 74 -8184 49 74 74 -8185 49 74 74 -8186 49 74 74 -8187 49 74 74 -8188 49 74 74 -8189 49 74 74 -8190 49 74 74 -8191 49 74 74 -8192 49 74 74 -8193 49 74 74 -8194 49 74 74 -8195 49 74 74 -8196 49 74 74 -8197 49 74 74 -8198 49 74 74 -8199 49 74 74 -8200 49 74 74 -8201 49 74 74 -8202 49 74 74 -8203 49 74 74 -8204 49 74 74 -8205 49 74 74 -8206 49 74 74 -8207 49 74 74 -8208 49 74 74 -8209 49 74 74 -8210 49 74 74 -8211 49 74 74 -8212 49 74 74 -8213 49 74 74 -8214 49 74 74 -8215 49 74 74 -8216 49 74 74 -8217 49 74 74 -8218 49 74 74 -8219 49 74 74 -8220 49 74 74 -8221 49 74 74 -8222 49 74 74 -8223 49 74 74 -8224 49 74 74 -8225 49 74 74 -8226 49 74 74 -8227 49 74 74 -8228 49 74 74 -8229 49 74 74 -8230 49 74 74 -8231 49 74 74 -8232 49 74 74 -8233 49 74 74 -8234 49 74 74 -8235 49 74 74 -8236 49 74 74 -8237 49 74 74 -8238 49 74 74 -8239 49 74 74 -8240 49 74 74 -8241 49 74 74 -8242 49 74 74 -8243 49 74 74 -8244 49 74 74 -8245 49 74 74 -8246 49 74 74 -8247 49 74 74 -8248 49 74 74 -8249 49 74 74 -8250 49 74 74 -8251 49 74 74 -8252 49 74 74 -8253 49 74 74 -8254 49 74 74 -8255 49 74 74 -8256 49 74 74 -8257 49 74 74 -8258 49 74 74 -8259 49 74 74 -8260 49 74 74 -8261 49 74 74 -8262 49 74 74 -8263 49 74 74 -8264 49 74 74 -8265 49 74 74 -8266 49 74 74 -8267 49 74 74 -8268 49 74 74 -8269 49 74 74 -8270 49 74 74 -8271 49 74 74 -8272 49 74 74 -8273 49 74 74 -8274 49 74 74 -8275 49 74 74 -8276 49 74 74 -8277 49 74 74 -8278 49 74 74 -8279 49 74 74 -8280 49 74 74 -8281 49 74 74 -8282 49 74 74 -8283 49 74 74 -8284 49 74 74 -8285 49 74 74 -8286 49 74 74 -8287 49 74 74 -8288 49 74 74 -8289 49 74 74 -8290 49 74 74 -8291 49 74 74 -8292 49 74 74 -8293 49 74 74 -8294 49 74 74 -8295 49 74 74 -8296 49 74 74 -8297 49 74 74 -8298 49 74 74 -8299 49 74 74 -8300 49 74 74 -8301 49 74 74 -8302 49 74 74 -8303 49 74 74 -8304 49 74 74 -8305 49 74 74 -8306 49 74 74 -8307 49 74 74 -8308 49 74 74 -8309 49 74 74 -8310 49 74 74 -8311 49 74 74 -8312 49 74 74 -8313 49 74 74 -8314 49 74 74 -8315 49 74 74 -8316 49 74 74 -8317 49 74 74 -8318 49 74 74 -8319 49 74 74 -8320 49 74 74 -8321 49 74 74 -8322 49 74 74 -8323 49 74 74 -8324 49 74 74 -8325 49 74 74 -8326 49 74 74 -8327 49 74 74 -8328 49 74 74 -8329 49 74 74 -8330 49 74 74 -8331 49 74 74 -8332 49 74 74 -8333 49 74 74 -8334 49 74 74 -8335 49 74 74 -8336 49 74 74 -8337 49 74 74 -8338 49 74 74 -8339 49 74 74 -8340 49 74 74 -8341 49 74 74 -8342 49 74 74 -8343 49 74 74 -8344 49 74 74 -8345 49 74 74 -8346 49 74 74 -8347 49 74 74 -8348 49 74 74 -8349 49 74 74 -8350 49 74 74 -8351 49 74 74 -8352 49 74 74 -8353 49 74 74 -8354 49 74 74 -8355 49 74 74 -8356 49 74 74 -8357 49 74 74 -8358 49 74 74 -8359 49 74 74 -8360 49 74 74 -8361 49 74 74 -8362 49 74 74 -8363 49 74 74 -8364 49 74 74 -8365 49 74 74 -8366 49 74 74 -8367 49 74 74 -8368 49 74 74 -8369 49 74 74 -8370 49 74 74 -8371 49 74 74 -8372 49 74 74 -8373 49 74 74 -8374 49 74 74 -8375 49 74 74 -8376 49 74 74 -8377 49 74 74 -8378 49 74 74 -8379 49 74 74 -8380 49 74 74 -8381 49 74 74 -8382 49 74 74 -8383 49 74 74 -8384 49 74 74 -8385 49 74 74 -8386 49 74 74 -8387 49 74 74 -8388 49 74 74 -8389 49 74 74 -8390 49 74 74 -8391 49 74 74 -8392 49 74 74 -8393 49 74 74 -8394 49 74 74 -8395 49 74 74 -8396 49 74 74 -8397 49 74 74 -8398 49 74 74 -8399 49 74 74 -8400 49 74 74 -8401 49 74 74 -8402 49 74 74 -8403 49 74 74 -8404 49 74 74 -8405 49 74 74 -8406 49 74 74 -8407 49 74 74 -8408 49 74 74 -8409 49 74 74 -8410 49 74 74 -8411 49 74 74 -8412 49 74 74 -8413 49 74 74 -8414 49 74 74 -8415 49 74 74 -8416 49 74 74 -8417 49 74 74 -8418 49 74 74 -8419 49 74 74 -8420 49 74 74 -8421 49 74 74 -8422 49 74 74 -8423 49 74 74 -8424 49 74 74 -8425 49 74 74 -8426 49 74 74 -8427 49 74 74 -8428 49 74 74 -8429 49 74 74 -8430 49 74 74 -8431 49 74 74 -8432 49 74 74 -8433 49 74 74 -8434 49 74 74 -8435 49 74 74 -8436 49 74 74 -8437 49 74 74 -8438 49 74 74 -8439 49 74 74 -8440 49 74 74 -8441 49 74 74 -8442 49 74 74 -8443 49 74 74 -8444 49 74 74 -8445 49 74 74 -8446 49 74 74 -8447 49 74 74 -8448 49 74 74 -8449 49 74 74 -8450 49 74 74 -8451 49 74 74 -8452 49 74 74 -8453 49 74 74 -8454 49 74 74 -8455 49 74 74 -8456 49 74 74 -8457 49 74 74 -8458 49 74 74 -8459 49 74 74 -8460 49 74 74 -8461 49 74 74 -8462 49 74 74 -8463 49 74 74 -8464 49 74 74 -8465 49 74 74 -8466 49 74 74 -8467 49 74 74 -8468 49 74 74 -8469 49 74 74 -8470 49 74 74 -8471 49 74 74 -8472 49 74 74 -8473 49 74 74 -8474 49 74 74 -8475 49 74 74 -8476 49 74 74 -8477 49 74 74 -8478 49 74 74 -8479 49 74 74 -8480 49 74 74 -8481 49 74 74 -8482 49 74 74 -8483 49 74 74 -8484 49 74 74 -8485 49 74 74 -8486 49 74 74 -8487 49 74 74 -8488 49 74 74 -8489 49 74 74 -8490 49 74 74 -8491 49 74 74 -8492 49 74 74 -8493 49 74 74 -8494 49 74 74 -8495 49 74 74 -8496 49 74 74 -8497 49 74 74 -8498 49 74 74 -8499 49 74 74 -8500 49 74 74 -8501 49 74 74 -8502 49 74 74 -8503 49 74 74 -8504 49 74 74 -8505 49 74 74 -8506 49 74 74 -8507 49 74 74 -8508 49 74 74 -8509 49 74 74 -8510 49 74 74 -8511 49 74 74 -8512 49 74 74 -8513 49 74 74 -8514 49 74 74 -8515 49 74 74 -8516 49 74 74 -8517 49 74 74 -8518 49 74 74 -8519 49 74 74 -8520 49 74 74 -8521 49 74 74 -8522 49 74 74 -8523 49 74 74 -8524 49 74 74 -8525 49 74 74 -8526 49 74 74 -8527 49 74 74 -8528 49 74 74 -8529 49 74 74 -8530 49 74 74 -8531 49 74 74 -8532 49 74 74 -8533 49 74 74 -8534 49 74 74 -8535 49 74 74 -8536 49 74 74 -8537 49 74 74 -8538 49 74 74 -8539 49 74 74 -8540 49 74 74 -8541 49 74 74 -8542 49 74 74 -8543 49 74 74 -8544 49 74 74 -8545 49 74 74 -8546 49 74 74 -8547 49 74 74 -8548 49 74 74 -8549 49 74 74 -8550 49 74 74 -8551 49 74 74 -8552 49 74 74 -8553 49 74 74 -8554 49 74 74 -8555 49 74 74 -8556 49 74 74 -8557 49 74 74 -8558 49 74 74 -8559 49 74 74 -8560 49 74 74 -8561 49 74 74 -8562 49 74 74 -8563 49 74 74 -8564 49 74 74 -8565 49 74 74 -8566 49 74 74 -8567 49 74 74 -8568 49 74 74 -8569 49 74 74 -8570 49 74 74 -8571 49 74 74 -8572 49 74 74 -8573 49 74 74 -8574 49 74 74 -8575 49 74 74 -8576 49 74 74 -8577 49 74 74 -8578 49 74 74 -8579 49 74 74 -8580 49 74 74 -8581 49 74 74 -8582 49 74 74 -8583 49 74 74 -8584 49 74 74 -8585 49 74 74 -8586 49 74 74 -8587 49 74 74 -8588 49 74 74 -8589 49 74 74 -8590 49 74 74 -8591 49 74 74 -8592 49 74 74 -8593 49 74 74 -8594 49 74 74 -8595 49 74 74 -8596 49 74 74 -8597 49 74 74 -8598 49 74 74 -8599 49 74 74 -8600 49 74 74 -8601 49 74 74 -8602 49 74 74 -8603 49 74 74 -8604 49 74 74 -8605 49 74 74 -8606 49 74 74 -8607 49 74 74 -8608 49 74 74 -8609 49 74 74 -8610 49 74 74 -8611 49 74 74 -8612 49 74 74 -8613 49 74 74 -8614 49 74 74 -8615 49 74 74 -8616 49 74 74 -8617 49 74 74 -8618 49 74 74 -8619 49 74 74 -8620 49 74 74 -8621 49 74 74 -8622 49 74 74 -8623 49 74 74 -8624 49 74 74 -8625 49 74 74 -8626 49 74 74 -8627 49 74 74 -8628 49 74 74 -8629 49 74 74 -8630 49 74 74 -8631 49 74 74 -8632 49 74 74 -8633 49 74 74 -8634 49 74 74 -8635 49 74 74 -8636 49 74 74 -8637 49 74 74 -8638 49 74 74 -8639 49 74 74 -8640 49 74 74 -8641 49 74 74 -8642 49 74 74 -8643 49 74 74 -8644 49 74 74 -8645 49 74 74 -8646 49 74 74 -8647 49 74 74 -8648 49 74 74 -8649 49 74 74 -8650 49 74 74 -8651 49 74 74 -8652 49 74 74 -8653 49 74 74 -8654 49 74 74 -8655 49 74 74 -8656 49 74 74 -8657 49 74 74 -8658 49 74 74 -8659 49 74 74 -8660 49 74 74 -8661 49 74 74 -8662 49 74 74 -8663 49 74 74 -8664 49 74 74 -8665 49 74 74 -8666 49 74 74 -8667 49 74 74 -8668 49 74 74 -8669 49 74 74 -8670 49 74 74 -8671 49 74 74 -8672 49 74 74 -8673 49 74 74 -8674 49 74 74 -8675 49 74 74 -8676 49 74 74 -8677 49 74 74 -8678 49 74 74 -8679 49 74 74 -8680 49 74 74 -8681 49 74 74 -8682 49 74 74 -8683 49 74 74 -8684 49 74 74 -8685 49 74 74 -8686 49 74 74 -8687 49 74 74 -8688 49 74 74 -8689 49 74 74 -8690 49 74 74 -8691 49 74 74 -8692 49 74 74 -8693 49 74 74 -8694 49 74 74 -8695 49 74 74 -8696 49 74 74 -8697 49 74 74 -8698 49 74 74 -8699 49 74 74 -8700 49 74 74 -8701 49 74 74 -8702 49 74 74 -8703 49 74 74 -8704 49 74 74 -8705 49 74 74 -8706 49 74 74 -8707 49 74 74 -8708 49 74 74 -8709 49 74 74 -8710 49 74 74 -8711 49 74 74 -8712 49 74 74 -8713 49 74 74 -8714 49 74 74 -8715 49 74 74 -8716 49 74 74 -8717 49 74 74 -8718 49 74 74 -8719 49 74 74 -8720 49 74 74 -8721 49 74 74 -8722 49 74 74 -8723 49 74 74 -8724 49 74 74 -8725 49 74 74 -8726 49 74 74 -8727 49 74 74 -8728 49 74 74 -8729 49 74 74 -8730 49 74 74 -8731 49 74 74 -8732 49 74 74 -8733 49 74 74 -8734 49 74 74 -8735 49 74 74 -8736 49 74 74 -8737 49 74 74 -8738 49 74 74 -8739 49 74 74 -8740 49 74 74 -8741 49 74 74 -8742 49 74 74 -8743 49 74 74 -8744 49 74 74 -8745 49 74 74 -8746 49 74 74 -8747 49 74 74 -8748 49 74 74 -8749 49 74 74 -8750 49 74 74 -8751 49 74 74 -8752 49 74 74 -8753 49 74 74 -8754 49 74 74 -8755 49 74 74 -8756 49 74 74 -8757 49 74 74 -8758 49 74 74 -8759 49 74 74 -8760 49 74 74 -8761 49 74 74 -8762 49 74 74 -8763 49 74 74 -8764 49 74 74 -8765 49 74 74 -8766 49 74 74 -8767 49 74 74 -8768 49 74 74 -8769 49 74 74 -8770 49 74 74 -8771 49 74 74 -8772 49 74 74 -8773 49 74 74 -8774 49 74 74 -8775 49 74 74 -8776 49 74 74 -8777 49 74 74 -8778 49 74 74 -8779 49 74 74 -8780 49 74 74 -8781 49 74 74 -8782 49 74 74 -8783 49 74 74 -8784 49 74 74 -8785 49 74 74 -8786 49 74 74 -8787 49 74 74 -8788 49 74 74 -8789 49 74 74 -8790 49 74 74 -8791 49 74 74 -8792 49 74 74 -8793 49 74 74 -8794 49 74 74 -8795 49 74 74 -8796 49 74 74 -8797 49 74 74 -8798 49 74 74 -8799 49 74 74 -8800 49 74 74 -8801 49 74 74 -8802 49 74 74 -8803 49 74 74 -8804 49 74 74 -8805 49 74 74 -8806 49 74 74 -8807 49 74 74 -8808 49 74 74 -8809 49 74 74 -8810 49 74 74 -8811 49 74 74 -8812 49 74 74 -8813 49 74 74 -8814 49 74 74 -8815 49 74 74 -8816 49 74 74 -8817 49 74 74 -8818 49 74 74 -8819 49 74 74 -8820 49 74 74 -8821 49 74 74 -8822 49 74 74 -8823 49 74 74 -8824 49 74 74 -8825 49 74 74 -8826 49 74 74 -8827 49 74 74 -8828 49 74 74 -8829 49 74 74 -8830 49 74 74 -8831 49 74 74 -8832 49 74 74 -8833 49 74 74 -8834 49 74 74 -8835 49 74 74 -8836 49 74 74 -8837 49 74 74 -8838 49 74 74 -8839 49 74 74 -8840 49 74 74 -8841 49 74 74 -8842 49 74 74 -8843 49 74 74 -8844 49 74 74 -8845 49 74 74 -8846 49 74 74 -8847 49 74 74 -8848 49 74 74 -8849 49 74 74 -8850 49 74 74 -8851 49 74 74 -8852 49 74 74 -8853 49 74 74 -8854 49 74 74 -8855 49 74 74 -8856 49 74 74 -8857 49 74 74 -8858 49 74 74 -8859 49 74 74 -8860 49 74 74 -8861 49 74 74 -8862 49 74 74 -8863 49 74 74 -8864 49 74 74 -8865 49 74 74 -8866 49 74 74 -8867 49 74 74 -8868 49 74 74 -8869 49 74 74 -8870 49 74 74 -8871 49 74 74 -8872 49 74 74 -8873 49 74 74 -8874 49 74 74 -8875 49 74 74 -8876 49 74 74 -8877 49 74 74 -8878 49 74 74 -8879 49 74 74 -8880 49 74 74 -8881 49 74 74 -8882 49 74 74 -8883 49 74 74 -8884 49 74 74 -8885 49 74 74 -8886 49 74 74 -8887 49 74 74 -8888 49 74 74 -8889 49 74 74 -8890 49 74 74 -8891 49 74 74 -8892 49 74 74 -8893 49 74 74 -8894 49 74 74 -8895 49 74 74 -8896 49 74 74 -8897 49 74 74 -8898 49 74 74 -8899 49 74 74 -8900 49 74 74 -8901 49 74 74 -8902 49 74 74 -8903 49 74 74 -8904 49 74 74 -8905 49 74 74 -8906 49 74 74 -8907 49 74 74 -8908 49 74 74 -8909 49 74 74 -8910 49 74 74 -8911 49 74 74 -8912 49 74 74 -8913 49 74 74 -8914 49 74 74 -8915 49 74 74 -8916 49 74 74 -8917 49 74 74 -8918 49 74 74 -8919 49 74 74 -8920 49 74 74 -8921 49 74 74 -8922 49 74 74 -8923 49 74 74 -8924 49 74 74 -8925 49 74 74 -8926 49 74 74 -8927 49 74 74 -8928 49 74 74 -8929 49 74 74 -8930 49 74 74 -8931 49 74 74 -8932 49 74 74 -8933 49 74 74 -8934 49 74 74 -8935 49 74 74 -8936 49 74 74 -8937 49 74 74 -8938 49 74 74 -8939 49 74 74 -8940 49 74 74 -8941 49 74 74 -8942 49 74 74 -8943 49 74 74 -8944 49 74 74 -8945 49 74 74 -8946 49 74 74 -8947 49 74 74 -8948 49 74 74 -8949 49 74 74 -8950 49 74 74 -8951 49 74 74 -8952 49 74 74 -8953 49 74 74 -8954 49 74 74 -8955 49 74 74 -8956 49 74 74 -8957 49 74 74 -8958 49 74 74 -8959 49 74 74 -8960 49 74 74 -8961 49 74 74 -8962 49 74 74 -8963 49 74 74 -8964 49 74 74 -8965 49 74 74 -8966 49 74 74 -8967 49 74 74 -8968 49 74 74 -8969 49 74 74 -8970 49 74 74 -8971 49 74 74 -8972 49 74 74 -8973 49 74 74 -8974 49 74 74 -8975 49 74 74 -8976 49 74 74 -8977 49 74 74 -8978 49 74 74 -8979 49 74 74 -8980 49 74 74 -8981 49 74 74 -8982 49 74 74 -8983 49 74 74 -8984 49 74 74 -8985 49 74 74 -8986 49 74 74 -8987 49 74 74 -8988 49 74 74 -8989 49 74 74 -8990 49 74 74 -8991 49 74 74 -8992 49 74 74 -8993 49 74 74 -8994 49 74 74 -8995 49 74 74 -8996 49 74 74 -8997 49 74 74 -8998 49 74 74 -8999 49 74 74 -9000 49 74 74 -9001 49 74 74 -9002 49 74 74 -9003 49 74 74 -9004 49 74 74 -9005 49 74 74 -9006 49 74 74 -9007 49 74 74 -9008 49 74 74 -9009 49 74 74 -9010 49 74 74 -9011 49 74 74 -9012 49 74 74 -9013 49 74 74 -9014 49 74 74 -9015 49 74 74 -9016 49 74 74 -9017 49 74 74 -9018 49 74 74 -9019 49 74 74 -9020 49 74 74 -9021 49 74 74 -9022 49 74 74 -9023 49 74 74 -9024 49 74 74 -9025 49 74 74 -9026 49 74 74 -9027 49 74 74 -9028 49 74 74 -9029 49 74 74 -9030 49 74 74 -9031 49 74 74 -9032 49 74 74 -9033 49 74 74 -9034 49 74 74 -9035 49 74 74 -9036 49 74 74 -9037 49 74 74 -9038 49 74 74 -9039 49 74 74 -9040 49 74 74 -9041 49 74 74 -9042 49 74 74 -9043 49 74 74 -9044 49 74 74 -9045 49 74 74 -9046 49 74 74 -9047 49 74 74 -9048 49 74 74 -9049 49 74 74 -9050 49 74 74 -9051 49 74 74 -9052 49 74 74 -9053 49 74 74 -9054 49 74 74 -9055 49 74 74 -9056 49 74 74 -9057 49 74 74 -9058 49 74 74 -9059 49 74 74 -9060 49 74 74 -9061 49 74 74 -9062 49 74 74 -9063 49 74 74 -9064 49 74 74 -9065 49 74 74 -9066 49 74 74 -9067 49 74 74 -9068 49 74 74 -9069 49 74 74 -9070 49 74 74 -9071 49 74 74 -9072 49 74 74 -9073 49 74 74 -9074 49 74 74 -9075 49 74 74 -9076 49 74 74 -9077 49 74 74 -9078 49 74 74 -9079 49 74 74 -9080 49 74 74 -9081 49 74 74 -9082 49 74 74 -9083 49 74 74 -9084 49 74 74 -9085 49 74 74 -9086 49 74 74 -9087 49 74 74 -9088 49 74 74 -9089 49 74 74 -9090 49 74 74 -9091 49 74 74 -9092 49 74 74 -9093 49 74 74 -9094 49 74 74 -9095 49 74 74 -9096 49 74 74 -9097 49 74 74 -9098 49 74 74 -9099 49 74 74 -9100 49 74 74 -9101 49 74 74 -9102 49 74 74 -9103 49 74 74 -9104 49 74 74 -9105 49 74 74 -9106 49 74 74 -9107 49 74 74 -9108 49 74 74 -9109 49 74 74 -9110 49 74 74 -9111 49 74 74 -9112 49 74 74 -9113 49 74 74 -9114 49 74 74 -9115 49 74 74 -9116 49 74 74 -9117 49 74 74 -9118 49 74 74 -9119 49 74 74 -9120 49 74 74 -9121 49 74 74 -9122 49 74 74 -9123 49 74 74 -9124 49 74 74 -9125 49 74 74 -9126 49 74 74 -9127 49 74 74 -9128 49 74 74 -9129 49 74 74 -9130 49 74 74 -9131 49 74 74 -9132 49 74 74 -9133 49 74 74 -9134 49 74 74 -9135 49 74 74 -9136 49 74 74 -9137 49 74 74 -9138 49 74 74 -9139 49 74 74 -9140 49 74 74 -9141 49 74 74 -9142 49 74 74 -9143 49 74 74 -9144 49 74 74 -9145 49 74 74 -9146 49 74 74 -9147 49 74 74 -9148 49 74 74 -9149 49 74 74 -9150 49 74 74 -9151 49 74 74 -9152 49 74 74 -9153 49 74 74 -9154 49 74 74 -9155 49 74 74 -9156 49 74 74 -9157 49 74 74 -9158 49 74 74 -9159 49 74 74 -9160 49 74 74 -9161 49 74 74 -9162 49 74 74 -9163 49 74 74 -9164 49 74 74 -9165 49 74 74 -9166 49 74 74 -9167 49 74 74 -9168 49 74 74 -9169 49 74 74 -9170 49 74 74 -9171 49 74 74 -9172 49 74 74 -9173 49 74 74 -9174 49 74 74 -9175 49 74 74 -9176 49 74 74 -9177 49 74 74 -9178 49 74 74 -9179 49 74 74 -9180 49 74 74 -9181 49 74 74 -9182 49 74 74 -9183 49 74 74 -9184 49 74 74 -9185 49 74 74 -9186 49 74 74 -9187 49 74 74 -9188 49 74 74 -9189 49 74 74 -9190 49 74 74 -9191 49 74 74 -9192 49 74 74 -9193 49 74 74 -9194 49 74 74 -9195 49 74 74 -9196 49 74 74 -9197 49 74 74 -9198 49 74 74 -9199 49 74 74 -9200 49 74 74 -9201 49 74 74 -9202 49 74 74 -9203 49 74 74 -9204 49 74 74 -9205 49 74 74 -9206 49 74 74 -9207 49 74 74 -9208 49 74 74 -9209 49 74 74 -9210 49 74 74 -9211 49 74 74 -9212 49 74 74 -9213 49 74 74 -9214 49 74 74 -9215 49 74 74 -9216 49 74 74 -9217 49 74 74 -9218 49 74 74 -9219 49 74 74 -9220 49 74 74 -9221 49 74 74 -9222 49 74 74 -9223 49 74 74 -9224 49 74 74 -9225 49 74 74 -9226 49 74 74 -9227 49 74 74 -9228 49 74 74 -9229 49 74 74 -9230 49 74 74 -9231 49 74 74 -9232 49 74 74 -9233 49 74 74 -9234 49 74 74 -9235 49 74 74 -9236 49 74 74 -9237 49 74 74 -9238 49 74 74 -9239 49 74 74 -9240 49 74 74 -9241 49 74 74 -9242 49 74 74 -9243 49 74 74 -9244 49 74 74 -9245 49 74 74 -9246 49 74 74 -9247 49 74 74 -9248 49 74 74 -9249 49 74 74 -9250 49 74 74 -9251 49 74 74 -9252 49 74 74 -9253 49 74 74 -9254 49 74 74 -9255 49 74 74 -9256 49 74 74 -9257 49 74 74 -9258 49 74 74 -9259 49 74 74 -9260 49 74 74 -9261 49 74 74 -9262 49 74 74 -9263 49 74 74 -9264 49 74 74 -9265 49 74 74 -9266 49 74 74 -9267 49 74 74 -9268 49 74 74 -9269 49 74 74 -9270 49 74 74 -9271 49 74 74 -9272 49 74 74 -9273 49 74 74 -9274 49 74 74 -9275 49 74 74 -9276 49 74 74 -9277 49 74 74 -9278 49 74 74 -9279 49 74 74 -9280 49 74 74 -9281 49 74 74 -9282 49 74 74 -9283 49 74 74 -9284 49 74 74 -9285 49 74 74 -9286 49 74 74 -9287 49 74 74 -9288 49 74 74 -9289 49 74 74 -9290 49 74 74 -9291 49 74 74 -9292 49 74 74 -9293 49 74 74 -9294 49 74 74 -9295 49 74 74 -9296 49 74 74 -9297 49 74 74 -9298 49 74 74 -9299 49 74 74 -9300 49 74 74 -9301 49 74 74 -9302 49 74 74 -9303 49 74 74 -9304 49 74 74 -9305 49 74 74 -9306 49 74 74 -9307 49 74 74 -9308 49 74 74 -9309 49 74 74 -9310 49 74 74 -9311 49 74 74 -9312 49 74 74 -9313 49 74 74 -9314 49 74 74 -9315 49 74 74 -9316 49 74 74 -9317 49 74 74 -9318 49 74 74 -9319 49 74 74 -9320 49 74 74 -9321 49 74 74 -9322 49 74 74 -9323 49 74 74 -9324 49 74 74 -9325 49 74 74 -9326 49 74 74 -9327 49 74 74 -9328 49 74 74 -9329 49 74 74 -9330 49 74 74 -9331 49 74 74 -9332 49 74 74 -9333 49 74 74 -9334 49 74 74 -9335 49 74 74 -9336 49 74 74 -9337 49 74 74 -9338 49 74 74 -9339 49 74 74 -9340 49 74 74 -9341 49 74 74 -9342 49 74 74 -9343 49 74 74 -9344 49 74 74 -9345 49 74 74 -9346 49 74 74 -9347 49 74 74 -9348 49 74 74 -9349 49 74 74 -9350 49 74 74 -9351 49 74 74 -9352 49 74 74 -9353 49 74 74 -9354 49 74 74 -9355 49 74 74 -9356 49 74 74 -9357 49 74 74 -9358 49 74 74 -9359 49 74 74 -9360 49 74 74 -9361 49 74 74 -9362 49 74 74 -9363 49 74 74 -9364 49 74 74 -9365 49 74 74 -9366 49 74 74 -9367 49 74 74 -9368 49 74 74 -9369 49 74 74 -9370 49 74 74 -9371 49 74 74 -9372 49 74 74 -9373 49 74 74 -9374 49 74 74 -9375 49 74 74 -9376 49 74 74 -9377 49 74 74 -9378 49 74 74 -9379 49 74 74 -9380 49 74 74 -9381 49 74 74 -9382 49 74 74 -9383 49 74 74 -9384 49 74 74 -9385 49 74 74 -9386 49 74 74 -9387 49 74 74 -9388 49 74 74 -9389 49 74 74 -9390 49 74 74 -9391 49 74 74 -9392 49 74 74 -9393 49 74 74 -9394 49 74 74 -9395 49 74 74 -9396 49 74 74 -9397 49 74 74 -9398 49 74 74 -9399 49 74 74 -9400 49 74 74 -9401 49 74 74 -9402 49 74 74 -9403 49 74 74 -9404 49 74 74 -9405 49 74 74 -9406 49 74 74 -9407 49 74 74 -9408 49 74 74 -9409 49 74 74 -9410 49 74 74 -9411 49 74 74 -9412 49 74 74 -9413 49 74 74 -9414 49 74 74 -9415 49 74 74 -9416 49 74 74 -9417 49 74 74 -9418 49 74 74 -9419 49 74 74 -9420 49 74 74 -9421 49 74 74 -9422 49 74 74 -9423 49 74 74 -9424 49 74 74 -9425 49 74 74 -9426 49 74 74 -9427 49 74 74 -9428 49 74 74 -9429 49 74 74 -9430 49 74 74 -9431 49 74 74 -9432 49 74 74 -9433 49 74 74 -9434 49 74 74 -9435 49 74 74 -9436 49 74 74 -9437 49 74 74 -9438 49 74 74 -9439 49 74 74 -9440 49 74 74 -9441 49 74 74 -9442 49 74 74 -9443 49 74 74 -9444 49 74 74 -9445 49 74 74 -9446 49 74 74 -9447 49 74 74 -9448 49 74 74 -9449 49 74 74 -9450 49 74 74 -9451 49 74 74 -9452 49 74 74 -9453 49 74 74 -9454 49 74 74 -9455 49 74 74 -9456 49 74 74 -9457 49 74 74 -9458 49 74 74 -9459 49 74 74 -9460 49 74 74 -9461 49 74 74 -9462 49 74 74 -9463 49 74 74 -9464 49 74 74 -9465 49 74 74 -9466 49 74 74 -9467 49 74 74 -9468 49 74 74 -9469 49 74 74 -9470 49 74 74 -9471 49 74 74 -9472 49 74 74 -9473 49 74 74 -9474 49 74 74 -9475 49 74 74 -9476 49 74 74 -9477 49 74 74 -9478 49 74 74 -9479 49 74 74 -9480 49 74 74 -9481 49 74 74 -9482 49 74 74 -9483 49 74 74 -9484 49 74 74 -9485 49 74 74 -9486 49 74 74 -9487 49 74 74 -9488 49 74 74 -9489 49 74 74 -9490 49 74 74 -9491 49 74 74 -9492 49 74 74 -9493 49 74 74 -9494 49 74 74 -9495 49 74 74 -9496 49 74 74 -9497 49 74 74 -9498 49 74 74 -9499 49 74 74 -9500 49 74 74 -9501 49 74 74 -9502 49 74 74 -9503 49 74 74 -9504 49 74 74 -9505 49 74 74 -9506 49 74 74 -9507 49 74 74 -9508 49 74 74 -9509 49 74 74 -9510 49 74 74 -9511 49 74 74 -9512 49 74 74 -9513 49 74 74 -9514 49 74 74 -9515 49 74 74 -9516 49 74 74 -9517 49 74 74 -9518 49 74 74 -9519 49 74 74 -9520 49 74 74 -9521 49 74 74 -9522 49 74 74 -9523 49 74 74 -9524 49 74 74 -9525 49 74 74 -9526 49 74 74 -9527 49 74 74 -9528 49 74 74 -9529 49 74 74 -9530 49 74 74 -9531 49 74 74 -9532 49 74 74 -9533 49 74 74 -9534 49 74 74 -9535 49 74 74 -9536 49 74 74 -9537 49 74 74 -9538 49 74 74 -9539 49 74 74 -9540 49 74 74 -9541 49 74 74 -9542 49 74 74 -9543 49 74 74 -9544 49 74 74 -9545 49 74 74 -9546 49 74 74 -9547 49 74 74 -9548 49 74 74 -9549 49 74 74 -9550 49 74 74 -9551 49 74 74 -9552 49 74 74 -9553 49 74 74 -9554 49 74 74 -9555 49 74 74 -9556 49 74 74 -9557 49 74 74 -9558 49 74 74 -9559 49 74 74 -9560 49 74 74 -9561 49 74 74 -9562 49 74 74 -9563 49 74 74 -9564 49 74 74 -9565 49 74 74 -9566 49 74 74 -9567 49 74 74 -9568 49 74 74 -9569 49 74 74 -9570 49 74 74 -9571 49 74 74 -9572 49 74 74 -9573 49 74 74 -9574 49 74 74 -9575 49 74 74 -9576 49 74 74 -9577 49 74 74 -9578 49 74 74 -9579 49 74 74 -9580 49 74 74 -9581 49 74 74 -9582 49 74 74 -9583 49 74 74 -9584 49 74 74 -9585 49 74 74 -9586 49 74 74 -9587 49 74 74 -9588 49 74 74 -9589 49 74 74 -9590 49 74 74 -9591 49 74 74 -9592 49 74 74 -9593 49 74 74 -9594 49 74 74 -9595 49 74 74 -9596 49 74 74 -9597 49 74 74 -9598 49 74 74 -9599 49 74 74 -9600 49 74 74 -9601 49 74 74 -9602 49 74 74 -9603 49 74 74 -9604 49 74 74 -9605 49 74 74 -9606 49 74 74 -9607 49 74 74 -9608 49 74 74 -9609 49 74 74 -9610 49 74 74 -9611 49 74 74 -9612 49 74 74 -9613 49 74 74 -9614 49 74 74 -9615 49 74 74 -9616 49 74 74 -9617 49 74 74 -9618 49 74 74 -9619 49 74 74 -9620 49 74 74 -9621 49 74 74 -9622 49 74 74 -9623 49 74 74 -9624 49 74 74 -9625 49 74 74 -9626 49 74 74 -9627 49 74 74 -9628 49 74 74 -9629 49 74 74 -9630 49 74 74 -9631 49 74 74 -9632 49 74 74 -9633 49 74 74 -9634 49 74 74 -9635 49 74 74 -9636 49 74 74 -9637 49 74 74 -9638 49 74 74 -9639 49 74 74 -9640 49 74 74 -9641 49 74 74 -9642 49 74 74 -9643 49 74 74 -9644 49 74 74 -9645 49 74 74 -9646 49 74 74 -9647 49 74 74 -9648 49 74 74 -9649 49 74 74 -9650 49 74 74 -9651 49 74 74 -9652 49 74 74 -9653 49 74 74 -9654 49 74 74 -9655 49 74 74 -9656 49 74 74 -9657 49 74 74 -9658 49 74 74 -9659 49 74 74 -9660 49 74 74 -9661 49 74 74 -9662 49 74 74 -9663 49 74 74 -9664 49 74 74 -9665 49 74 74 -9666 49 74 74 -9667 49 74 74 -9668 49 74 74 -9669 49 74 74 -9670 49 74 74 -9671 49 74 74 -9672 49 74 74 -9673 49 74 74 -9674 49 74 74 -9675 49 74 74 -9676 49 74 74 -9677 49 74 74 -9678 49 74 74 -9679 49 74 74 -9680 49 74 74 -9681 49 74 74 -9682 49 74 74 -9683 49 74 74 -9684 49 74 74 -9685 49 74 74 -9686 49 74 74 -9687 49 74 74 -9688 49 74 74 -9689 49 74 74 -9690 49 74 74 -9691 49 74 74 -9692 49 74 74 -9693 49 74 74 -9694 49 74 74 -9695 49 74 74 -9696 49 74 74 -9697 49 74 74 -9698 49 74 74 -9699 49 74 74 -9700 49 74 74 -9701 49 74 74 -9702 49 74 74 -9703 49 74 74 -9704 49 74 74 -9705 49 74 74 -9706 49 74 74 -9707 49 74 74 -9708 49 74 74 -9709 49 74 74 -9710 49 74 74 -9711 49 74 74 -9712 49 74 74 -9713 49 74 74 -9714 49 74 74 -9715 49 74 74 -9716 49 74 74 -9717 49 74 74 -9718 49 74 74 -9719 49 74 74 -9720 49 74 74 -9721 49 74 74 -9722 49 74 74 -9723 49 74 74 -9724 49 74 74 -9725 49 74 74 -9726 49 74 74 -9727 49 74 74 -9728 49 74 74 -9729 49 74 74 -9730 49 74 74 -9731 49 74 74 -9732 49 74 74 -9733 49 74 74 -9734 49 74 74 -9735 49 74 74 -9736 49 74 74 -9737 49 74 74 -9738 49 74 74 -9739 49 74 74 -9740 49 74 74 -9741 49 74 74 -9742 49 74 74 -9743 49 74 74 +6909 49 1234 1235 +6910 49 1237 1238 +6911 49 1240 1241 +6912 49 1243 1244 +6913 49 1246 1247 +6914 49 1249 1250 +6915 49 1252 1253 +6916 49 1255 1256 +6917 49 1258 1259 +6918 49 1261 1262 +6919 49 1264 1265 +6920 49 1267 1268 +6921 49 1270 1271 +6922 49 1273 1274 +6923 49 1276 1277 +6924 49 1279 1280 +6925 49 1282 1283 +6926 49 1285 1286 +6927 49 1288 1289 +6928 49 1291 1292 +6929 49 1294 1295 +6930 49 1297 1298 +6931 49 1300 1301 +6932 49 1303 1304 +6933 49 1306 1307 +6934 49 1309 1310 +6935 49 1312 1313 +6936 49 1315 1316 +6937 49 1318 1319 +6938 49 1321 1322 +6939 49 1324 1325 +6940 49 1327 1328 +6941 49 1330 1331 +6942 49 1333 1334 +6943 49 1336 1337 +6944 49 1339 1340 +6945 49 1342 1343 +6946 49 1345 1346 +6947 49 1348 1349 +6948 49 1351 1352 +6949 49 1354 1355 +6950 49 1357 1358 +6951 49 1360 1361 +6952 49 1363 1364 +6953 49 1366 1367 +6954 49 1369 1370 +6955 49 1372 1373 +6956 49 1375 1376 +6957 49 1378 1379 +6958 49 1381 1382 +6959 49 1384 1385 +6960 49 1387 1388 +6961 49 1390 1391 +6962 49 1393 1394 +6963 49 1396 1397 +6964 49 1399 1400 +6965 49 1402 1403 +6966 49 1405 1406 +6967 49 1408 1409 +6968 49 1411 1412 +6969 49 1414 1415 +6970 49 1417 1418 +6971 49 1420 1421 +6972 49 1423 1424 +6973 49 1426 1427 +6974 49 1429 1430 +6975 49 1432 1433 +6976 49 1435 1436 +6977 49 1438 1439 +6978 49 1441 1442 +6979 49 1444 1445 +6980 49 1447 1448 +6981 49 1450 1451 +6982 49 1453 1454 +6983 49 1456 1457 +6984 49 1459 1460 +6985 49 1462 1463 +6986 49 1465 1466 +6987 49 1468 1469 +6988 49 1471 1472 +6989 49 1474 1475 +6990 49 1477 1478 +6991 49 1480 1481 +6992 49 1483 1484 +6993 49 1486 1487 +6994 49 1489 1490 +6995 49 1492 1493 +6996 49 1495 1496 +6997 49 1498 1499 +6998 49 1501 1502 +6999 49 1504 1505 +7000 49 1507 1508 +7001 49 1510 1511 +7002 49 1513 1514 +7003 49 1516 1517 +7004 49 1519 1520 +7005 49 1522 1523 +7006 49 1525 1526 +7007 49 1528 1529 +7008 49 1531 1532 +7009 49 1534 1535 +7010 49 1537 1538 +7011 49 1540 1541 +7012 49 1543 1544 +7013 49 1546 1547 +7014 49 1549 1550 +7015 49 1552 1553 +7016 49 1555 1556 +7017 49 1558 1559 +7018 49 1561 1562 +7019 49 1564 1565 +7020 49 1567 1568 +7021 49 1570 1571 +7022 49 1573 1574 +7023 49 1576 1577 +7024 49 1579 1580 +7025 49 1582 1583 +7026 49 1585 1586 +7027 49 1588 1589 +7028 49 1591 1592 +7029 49 1594 1595 +7030 49 1597 1598 +7031 49 1600 1601 +7032 49 1603 1604 +7033 49 1606 1607 +7034 49 1609 1610 +7035 49 1612 1613 +7036 49 1615 1616 +7037 49 1618 1619 +7038 49 1621 1622 +7039 49 1624 1625 +7040 49 1627 1628 +7041 49 1630 1631 +7042 49 1633 1634 +7043 49 1636 1637 +7044 49 1639 1640 +7045 49 1642 1643 +7046 49 1645 1646 +7047 49 1648 1649 +7048 49 1651 1652 +7049 49 1654 1655 +7050 49 1657 1658 +7051 49 1660 1661 +7052 49 1663 1664 +7053 49 1666 1667 +7054 49 1669 1670 +7055 49 1672 1673 +7056 49 1675 1676 +7057 49 1678 1679 +7058 49 1681 1682 +7059 49 1684 1685 +7060 49 1687 1688 +7061 49 1690 1691 +7062 49 1693 1694 +7063 49 1696 1697 +7064 49 1699 1700 +7065 49 1702 1703 +7066 49 1705 1706 +7067 49 1708 1709 +7068 49 1711 1712 +7069 49 1714 1715 +7070 49 1717 1718 +7071 49 1720 1721 +7072 49 1723 1724 +7073 49 1726 1727 +7074 49 1729 1730 +7075 49 1732 1733 +7076 49 1735 1736 +7077 49 1738 1739 +7078 49 1741 1742 +7079 49 1744 1745 +7080 49 1747 1748 +7081 49 1750 1751 +7082 49 1753 1754 +7083 49 1756 1757 +7084 49 1759 1760 +7085 49 1762 1763 +7086 49 1765 1766 +7087 49 1768 1769 +7088 49 1771 1772 +7089 49 1774 1775 +7090 49 1777 1778 +7091 49 1780 1781 +7092 49 1783 1784 +7093 49 1786 1787 +7094 49 1789 1790 +7095 49 1792 1793 +7096 49 1795 1796 +7097 49 1798 1799 +7098 49 1801 1802 +7099 49 1804 1805 +7100 49 1807 1808 +7101 49 1810 1811 +7102 49 1813 1814 +7103 49 1816 1817 +7104 49 1819 1820 +7105 49 1822 1823 +7106 49 1825 1826 +7107 49 1828 1829 +7108 49 1831 1832 +7109 49 1834 1835 +7110 49 1837 1838 +7111 49 1840 1841 +7112 49 1843 1844 +7113 49 1846 1847 +7114 49 1849 1850 +7115 49 1852 1853 +7116 49 1855 1856 +7117 49 1858 1859 +7118 49 1861 1862 +7119 49 1864 1865 +7120 49 1867 1868 +7121 49 1870 1871 +7122 49 1873 1874 +7123 49 1876 1877 +7124 49 1879 1880 +7125 49 1882 1883 +7126 49 1885 1886 +7127 49 1888 1889 +7128 49 1891 1892 +7129 49 1894 1895 +7130 49 1897 1898 +7131 49 1900 1901 +7132 49 1903 1904 +7133 49 1906 1907 +7134 49 1909 1910 +7135 49 1912 1913 +7136 49 1915 1916 +7137 49 1918 1919 +7138 49 1921 1922 +7139 49 1924 1925 +7140 49 1927 1928 +7141 49 1930 1931 +7142 49 1933 1934 +7143 49 1936 1937 +7144 49 1939 1940 +7145 49 1942 1943 +7146 49 1945 1946 +7147 49 1948 1949 +7148 49 1951 1952 +7149 49 1954 1955 +7150 49 1957 1958 +7151 49 1960 1961 +7152 49 1963 1964 +7153 49 1966 1967 +7154 49 1969 1970 +7155 49 1972 1973 +7156 49 1975 1976 +7157 49 1978 1979 +7158 49 1981 1982 +7159 49 1984 1985 +7160 49 1987 1988 +7161 49 1990 1991 +7162 49 1993 1994 +7163 49 1996 1997 +7164 49 1999 2000 +7165 49 2002 2003 +7166 49 2005 2006 +7167 49 2008 2009 +7168 49 2011 2012 +7169 49 2014 2015 +7170 49 2017 2018 +7171 49 2020 2021 +7172 49 2023 2024 +7173 49 2026 2027 +7174 49 2029 2030 +7175 49 2032 2033 +7176 49 2035 2036 +7177 49 2038 2039 +7178 49 2041 2042 +7179 49 2044 2045 +7180 49 2047 2048 +7181 49 2050 2051 +7182 49 2053 2054 +7183 49 2056 2057 +7184 49 2059 2060 +7185 49 2062 2063 +7186 49 2065 2066 +7187 49 2068 2069 +7188 49 2071 2072 +7189 49 2074 2075 +7190 49 2077 2078 +7191 49 2080 2081 +7192 49 2083 2084 +7193 49 2086 2087 +7194 49 2089 2090 +7195 49 2092 2093 +7196 49 2095 2096 +7197 49 2098 2099 +7198 49 2101 2102 +7199 49 2104 2105 +7200 49 2107 2108 +7201 49 2110 2111 +7202 49 2113 2114 +7203 49 2116 2117 +7204 49 2119 2120 +7205 49 2122 2123 +7206 49 2125 2126 +7207 49 2128 2129 +7208 49 2131 2132 +7209 49 2134 2135 +7210 49 2137 2138 +7211 49 2140 2141 +7212 49 2143 2144 +7213 49 2146 2147 +7214 49 2149 2150 +7215 49 2152 2153 +7216 49 2155 2156 +7217 49 2158 2159 +7218 49 2161 2162 +7219 49 2164 2165 +7220 49 2167 2168 +7221 49 2170 2171 +7222 49 2173 2174 +7223 49 2176 2177 +7224 49 2179 2180 +7225 49 2182 2183 +7226 49 2185 2186 +7227 49 2188 2189 +7228 49 2191 2192 +7229 49 2194 2195 +7230 49 2197 2198 +7231 49 2200 2201 +7232 49 2203 2204 +7233 49 2206 2207 +7234 49 2209 2210 +7235 49 2212 2213 +7236 49 2215 2216 +7237 49 2218 2219 +7238 49 2221 2222 +7239 49 2224 2225 +7240 49 2227 2228 +7241 49 2230 2231 +7242 49 2233 2234 +7243 49 2236 2237 +7244 49 2239 2240 +7245 49 2242 2243 +7246 49 2245 2246 +7247 49 2248 2249 +7248 49 2251 2252 +7249 49 2254 2255 +7250 49 2257 2258 +7251 49 2260 2261 +7252 49 2263 2264 +7253 49 2266 2267 +7254 49 2269 2270 +7255 49 2272 2273 +7256 49 2275 2276 +7257 49 2278 2279 +7258 49 2281 2282 +7259 49 2284 2285 +7260 49 2287 2288 +7261 49 2290 2291 +7262 49 2293 2294 +7263 49 2296 2297 +7264 49 2299 2300 +7265 49 2302 2303 +7266 49 2305 2306 +7267 49 2308 2309 +7268 49 2311 2312 +7269 49 2314 2315 +7270 49 2317 2318 +7271 49 2320 2321 +7272 49 2323 2324 +7273 49 2326 2327 +7274 49 2329 2330 +7275 49 2332 2333 +7276 49 2335 2336 +7277 49 2338 2339 +7278 49 2341 2342 +7279 49 2344 2345 +7280 49 2347 2348 +7281 49 2350 2351 +7282 49 2353 2354 +7283 49 2356 2357 +7284 49 2359 2360 +7285 49 2362 2363 +7286 49 2365 2366 +7287 49 2368 2369 +7288 49 2371 2372 +7289 49 2374 2375 +7290 49 2377 2378 +7291 49 2380 2381 +7292 49 2383 2384 +7293 49 2386 2387 +7294 49 2389 2390 +7295 49 2392 2393 +7296 49 2395 2396 +7297 49 2398 2399 +7298 49 2401 2402 +7299 49 2404 2405 +7300 49 2407 2408 +7301 49 2410 2411 +7302 49 2413 2414 +7303 49 2416 2417 +7304 49 2419 2420 +7305 49 2422 2423 +7306 49 2425 2426 +7307 49 2428 2429 +7308 49 2431 2432 +7309 49 2434 2435 +7310 49 2437 2438 +7311 49 2440 2441 +7312 49 2443 2444 +7313 49 2446 2447 +7314 49 2449 2450 +7315 49 2452 2453 +7316 49 2455 2456 +7317 49 2458 2459 +7318 49 2461 2462 +7319 49 2464 2465 +7320 49 2467 2468 +7321 49 2470 2471 +7322 49 2473 2474 +7323 49 2476 2477 +7324 49 2479 2480 +7325 49 2482 2483 +7326 49 2485 2486 +7327 49 2488 2489 +7328 49 2491 2492 +7329 49 2494 2495 +7330 49 2497 2498 +7331 49 2500 2501 +7332 49 2503 2504 +7333 49 2506 2507 +7334 49 2509 2510 +7335 49 2512 2513 +7336 49 2515 2516 +7337 49 2518 2519 +7338 49 2521 2522 +7339 49 2524 2525 +7340 49 2527 2528 +7341 49 2530 2531 +7342 49 2533 2534 +7343 49 2536 2537 +7344 49 2539 2540 +7345 49 2542 2543 +7346 49 2545 2546 +7347 49 2548 2549 +7348 49 2551 2552 +7349 49 2554 2555 +7350 49 2557 2558 +7351 49 2560 2561 +7352 49 2563 2564 +7353 49 2566 2567 +7354 49 2569 2570 +7355 49 2572 2573 +7356 49 2575 2576 +7357 49 2578 2579 +7358 49 2581 2582 +7359 49 2584 2585 +7360 49 2587 2588 +7361 49 2590 2591 +7362 49 2593 2594 +7363 49 2596 2597 +7364 49 2599 2600 +7365 49 2602 2603 +7366 49 2605 2606 +7367 49 2608 2609 +7368 49 2611 2612 +7369 49 2614 2615 +7370 49 2617 2618 +7371 49 2620 2621 +7372 49 2623 2624 +7373 49 2626 2627 +7374 49 2629 2630 +7375 49 2632 2633 +7376 49 2635 2636 +7377 49 2638 2639 +7378 49 2641 2642 +7379 49 2644 2645 +7380 49 2647 2648 +7381 49 2650 2651 +7382 49 2653 2654 +7383 49 2656 2657 +7384 49 2659 2660 +7385 49 2662 2663 +7386 49 2665 2666 +7387 49 2668 2669 +7388 49 2671 2672 +7389 49 2674 2675 +7390 49 2677 2678 +7391 49 2680 2681 +7392 49 2683 2684 +7393 49 2686 2687 +7394 49 2689 2690 +7395 49 2692 2693 +7396 49 2695 2696 +7397 49 2698 2699 +7398 49 2701 2702 +7399 49 2704 2705 +7400 49 2707 2708 +7401 49 2710 2711 +7402 49 2713 2714 +7403 49 2716 2717 +7404 49 2719 2720 +7405 49 2722 2723 +7406 49 2725 2726 +7407 49 2728 2729 +7408 49 2731 2732 +7409 49 2734 2735 +7410 49 2737 2738 +7411 49 2740 2741 +7412 49 2743 2744 +7413 49 2746 2747 +7414 49 2749 2750 +7415 49 2752 2753 +7416 49 2755 2756 +7417 49 2758 2759 +7418 49 2761 2762 +7419 49 2764 2765 +7420 49 2767 2768 +7421 49 2770 2771 +7422 49 2773 2774 +7423 49 2776 2777 +7424 49 2779 2780 +7425 49 2782 2783 +7426 49 2785 2786 +7427 49 2788 2789 +7428 49 2791 2792 +7429 49 2794 2795 +7430 49 2797 2798 +7431 49 2800 2801 +7432 49 2803 2804 +7433 49 2806 2807 +7434 49 2809 2810 +7435 49 2812 2813 +7436 49 2815 2816 +7437 49 2818 2819 +7438 49 2821 2822 +7439 49 2824 2825 +7440 49 2827 2828 +7441 49 2830 2831 +7442 49 2833 2834 +7443 49 2836 2837 +7444 49 2839 2840 +7445 49 2842 2843 +7446 49 2845 2846 +7447 49 2848 2849 +7448 49 2851 2852 +7449 49 2854 2855 +7450 49 2857 2858 +7451 49 2860 2861 +7452 49 2863 2864 +7453 49 2866 2867 +7454 49 2869 2870 +7455 49 2872 2873 +7456 49 2875 2876 +7457 49 2878 2879 +7458 49 2881 2882 +7459 49 2884 2885 +7460 49 2887 2888 +7461 49 2890 2891 +7462 49 2893 2894 +7463 49 2896 2897 +7464 49 2899 2900 +7465 49 2902 2903 +7466 49 2905 2906 +7467 49 2908 2909 +7468 49 2911 2912 +7469 49 2914 2915 +7470 49 2917 2918 +7471 49 2920 2921 +7472 49 2923 2924 +7473 49 2926 2927 +7474 49 2929 2930 +7475 49 2932 2933 +7476 49 2935 2936 +7477 49 2938 2939 +7478 49 2941 2942 +7479 49 2944 2945 +7480 49 2947 2948 +7481 49 2950 2951 +7482 49 2953 2954 +7483 49 2956 2957 +7484 49 2959 2960 +7485 49 2962 2963 +7486 49 2965 2966 +7487 49 2968 2969 +7488 49 2971 2972 +7489 49 2974 2975 +7490 49 2977 2978 +7491 49 2980 2981 +7492 49 2983 2984 +7493 49 2986 2987 +7494 49 2989 2990 +7495 49 2992 2993 +7496 49 2995 2996 +7497 49 2998 2999 +7498 49 3001 3002 +7499 49 3004 3005 +7500 49 3007 3008 +7501 49 3010 3011 +7502 49 3013 3014 +7503 49 3016 3017 +7504 49 3019 3020 +7505 49 3022 3023 +7506 49 3025 3026 +7507 49 3028 3029 +7508 49 3031 3032 +7509 49 3034 3035 +7510 49 3037 3038 +7511 49 3040 3041 +7512 49 3043 3044 +7513 49 3046 3047 +7514 49 3049 3050 +7515 49 3052 3053 +7516 49 3055 3056 +7517 49 3058 3059 +7518 49 3061 3062 +7519 49 3064 3065 +7520 49 3067 3068 +7521 49 3070 3071 +7522 49 3073 3074 +7523 49 3076 3077 +7524 49 3079 3080 +7525 49 3082 3083 +7526 49 3085 3086 +7527 49 3088 3089 +7528 49 3091 3092 +7529 49 3094 3095 +7530 49 3097 3098 +7531 49 3100 3101 +7532 49 3103 3104 +7533 49 3106 3107 +7534 49 3109 3110 +7535 49 3112 3113 +7536 49 3115 3116 +7537 49 3118 3119 +7538 49 3121 3122 +7539 49 3124 3125 +7540 49 3127 3128 +7541 49 3130 3131 +7542 49 3133 3134 +7543 49 3136 3137 +7544 49 3139 3140 +7545 49 3142 3143 +7546 49 3145 3146 +7547 49 3148 3149 +7548 49 3151 3152 +7549 49 3154 3155 +7550 49 3157 3158 +7551 49 3160 3161 +7552 49 3163 3164 +7553 49 3166 3167 +7554 49 3169 3170 +7555 49 3172 3173 +7556 49 3175 3176 +7557 49 3178 3179 +7558 49 3181 3182 +7559 49 3184 3185 +7560 49 3187 3188 +7561 49 3190 3191 +7562 49 3193 3194 +7563 49 3196 3197 +7564 49 3199 3200 +7565 49 3202 3203 +7566 49 3205 3206 +7567 49 3208 3209 +7568 49 3211 3212 +7569 49 3214 3215 +7570 49 3217 3218 +7571 49 3220 3221 +7572 49 3223 3224 +7573 49 3226 3227 +7574 49 3229 3230 +7575 49 3232 3233 +7576 49 3235 3236 +7577 49 3238 3239 +7578 49 3241 3242 +7579 49 3244 3245 +7580 49 3247 3248 +7581 49 3250 3251 +7582 49 3253 3254 +7583 49 3256 3257 +7584 49 3259 3260 +7585 49 3262 3263 +7586 49 3265 3266 +7587 49 3268 3269 +7588 49 3271 3272 +7589 49 3274 3275 +7590 49 3277 3278 +7591 49 3280 3281 +7592 49 3283 3284 +7593 49 3286 3287 +7594 49 3289 3290 +7595 49 3292 3293 +7596 49 3295 3296 +7597 49 3298 3299 +7598 49 3301 3302 +7599 49 3304 3305 +7600 49 3307 3308 +7601 49 3310 3311 +7602 49 3313 3314 +7603 49 3316 3317 +7604 49 3319 3320 +7605 49 3322 3323 +7606 49 3325 3326 +7607 49 3328 3329 +7608 49 3331 3332 +7609 49 3334 3335 +7610 49 3337 3338 +7611 49 3340 3341 +7612 49 3343 3344 +7613 49 3346 3347 +7614 49 3349 3350 +7615 49 3352 3353 +7616 49 3355 3356 +7617 49 3358 3359 +7618 49 3361 3362 +7619 49 3364 3365 +7620 49 3367 3368 +7621 49 3370 3371 +7622 49 3373 3374 +7623 49 3376 3377 +7624 49 3379 3380 +7625 49 3382 3383 +7626 49 3385 3386 +7627 49 3388 3389 +7628 49 3391 3392 +7629 49 3394 3395 +7630 49 3397 3398 +7631 49 3400 3401 +7632 49 3403 3404 +7633 49 3406 3407 +7634 49 3409 3410 +7635 49 3412 3413 +7636 49 3415 3416 +7637 49 3418 3419 +7638 49 3421 3422 +7639 49 3424 3425 +7640 49 3427 3428 +7641 49 3430 3431 +7642 49 3433 3434 +7643 49 3436 3437 +7644 49 3439 3440 +7645 49 3442 3443 +7646 49 3445 3446 +7647 49 3448 3449 +7648 49 3451 3452 +7649 49 3454 3455 +7650 49 3457 3458 +7651 49 3460 3461 +7652 49 3463 3464 +7653 49 3466 3467 +7654 49 3469 3470 +7655 49 3472 3473 +7656 49 3475 3476 +7657 49 3478 3479 +7658 49 3481 3482 +7659 49 3484 3485 +7660 49 3487 3488 +7661 49 3490 3491 +7662 49 3493 3494 +7663 49 3496 3497 +7664 49 3499 3500 +7665 49 3502 3503 +7666 49 3505 3506 +7667 49 3508 3509 +7668 49 3511 3512 +7669 49 3514 3515 +7670 49 3517 3518 +7671 49 3520 3521 +7672 49 3523 3524 +7673 49 3526 3527 +7674 49 3529 3530 +7675 49 3532 3533 +7676 49 3535 3536 +7677 49 3538 3539 +7678 49 3541 3542 +7679 49 3544 3545 +7680 49 3547 3548 +7681 49 3550 3551 +7682 49 3553 3554 +7683 49 3556 3557 +7684 49 3559 3560 +7685 49 3562 3563 +7686 49 3565 3566 +7687 49 3568 3569 +7688 49 3571 3572 +7689 49 3574 3575 +7690 49 3577 3578 +7691 49 3580 3581 +7692 49 3583 3584 +7693 49 3586 3587 +7694 49 3589 3590 +7695 49 3592 3593 +7696 49 3595 3596 +7697 49 3598 3599 +7698 49 3601 3602 +7699 49 3604 3605 +7700 49 3607 3608 +7701 49 3610 3611 +7702 49 3613 3614 +7703 49 3616 3617 +7704 49 3619 3620 +7705 49 3622 3623 +7706 49 3625 3626 +7707 49 3628 3629 +7708 49 3631 3632 +7709 49 3634 3635 +7710 49 3637 3638 +7711 49 3640 3641 +7712 49 3643 3644 +7713 49 3646 3647 +7714 49 3649 3650 +7715 49 3652 3653 +7716 49 3655 3656 +7717 49 3658 3659 +7718 49 3661 3662 +7719 49 3664 3665 +7720 49 3667 3668 +7721 49 3670 3671 +7722 49 3673 3674 +7723 49 3676 3677 +7724 49 3679 3680 +7725 49 3682 3683 +7726 49 3685 3686 +7727 49 3688 3689 +7728 49 3691 3692 +7729 49 3694 3695 +7730 49 3697 3698 +7731 49 3700 3701 +7732 49 3703 3704 +7733 49 3706 3707 +7734 49 3709 3710 +7735 49 3712 3713 +7736 49 3715 3716 +7737 49 3718 3719 +7738 49 3721 3722 +7739 49 3724 3725 +7740 49 3727 3728 +7741 49 3730 3731 +7742 49 3733 3734 +7743 49 3736 3737 +7744 49 3739 3740 +7745 49 3742 3743 +7746 49 3745 3746 +7747 49 3748 3749 +7748 49 3751 3752 +7749 49 3754 3755 +7750 49 3757 3758 +7751 49 3760 3761 +7752 49 3763 3764 +7753 49 3766 3767 +7754 49 3769 3770 +7755 49 3772 3773 +7756 49 3775 3776 +7757 49 3778 3779 +7758 49 3781 3782 +7759 49 3784 3785 +7760 49 3787 3788 +7761 49 3790 3791 +7762 49 3793 3794 +7763 49 3796 3797 +7764 49 3799 3800 +7765 49 3802 3803 +7766 49 3805 3806 +7767 49 3808 3809 +7768 49 3811 3812 +7769 49 3814 3815 +7770 49 3817 3818 +7771 49 3820 3821 +7772 49 3823 3824 +7773 49 3826 3827 +7774 49 3829 3830 +7775 49 3832 3833 +7776 49 3835 3836 +7777 49 3838 3839 +7778 49 3841 3842 +7779 49 3844 3845 +7780 49 3847 3848 +7781 49 3850 3851 +7782 49 3853 3854 +7783 49 3856 3857 +7784 49 3859 3860 +7785 49 3862 3863 +7786 49 3865 3866 +7787 49 3868 3869 +7788 49 3871 3872 +7789 49 3874 3875 +7790 49 3877 3878 +7791 49 3880 3881 +7792 49 3883 3884 +7793 49 3886 3887 +7794 49 3889 3890 +7795 49 3892 3893 +7796 49 3895 3896 +7797 49 3898 3899 +7798 49 3901 3902 +7799 49 3904 3905 +7800 49 3907 3908 +7801 49 3910 3911 +7802 49 3913 3914 +7803 49 3916 3917 +7804 49 3919 3920 +7805 49 3922 3923 +7806 49 3925 3926 +7807 49 3928 3929 +7808 49 3931 3932 +7809 49 3934 3935 +7810 49 3937 3938 +7811 49 3940 3941 +7812 49 3943 3944 +7813 49 3946 3947 +7814 49 3949 3950 +7815 49 3952 3953 +7816 49 3955 3956 +7817 49 3958 3959 +7818 49 3961 3962 +7819 49 3964 3965 +7820 49 3967 3968 +7821 49 3970 3971 +7822 49 3973 3974 +7823 49 3976 3977 +7824 49 3979 3980 +7825 49 3982 3983 +7826 49 3985 3986 +7827 49 3988 3989 +7828 49 3991 3992 +7829 49 3994 3995 +7830 49 3997 3998 +7831 49 4000 4001 +7832 49 4003 4004 +7833 49 4006 4007 +7834 49 4009 4010 +7835 49 4012 4013 +7836 49 4015 4016 +7837 49 4018 4019 +7838 49 4021 4022 +7839 49 4024 4025 +7840 49 4027 4028 +7841 49 4030 4031 +7842 49 4033 4034 +7843 49 4036 4037 +7844 49 4039 4040 +7845 49 4042 4043 +7846 49 4045 4046 +7847 49 4048 4049 +7848 49 4051 4052 +7849 49 4054 4055 +7850 49 4057 4058 +7851 49 4060 4061 +7852 49 4063 4064 +7853 49 4066 4067 +7854 49 4069 4070 +7855 49 4072 4073 +7856 49 4075 4076 +7857 49 4078 4079 +7858 49 4081 4082 +7859 49 4084 4085 +7860 49 4087 4088 +7861 49 4090 4091 +7862 49 4093 4094 +7863 49 4096 4097 +7864 49 4099 4100 +7865 49 4102 4103 +7866 49 4105 4106 +7867 49 4108 4109 +7868 49 4111 4112 +7869 49 4114 4115 +7870 49 4117 4118 +7871 49 4120 4121 +7872 49 4123 4124 +7873 49 4126 4127 +7874 49 4129 4130 +7875 49 4132 4133 +7876 49 4135 4136 +7877 49 4138 4139 +7878 49 4141 4142 +7879 49 4144 4145 +7880 49 4147 4148 +7881 49 4150 4151 +7882 49 4153 4154 +7883 49 4156 4157 +7884 49 4159 4160 +7885 49 4162 4163 +7886 49 4165 4166 +7887 49 4168 4169 +7888 49 4171 4172 +7889 49 4174 4175 +7890 49 4177 4178 +7891 49 4180 4181 +7892 49 4183 4184 +7893 49 4186 4187 +7894 49 4189 4190 +7895 49 4192 4193 +7896 49 4195 4196 +7897 49 4198 4199 +7898 49 4201 4202 +7899 49 4204 4205 +7900 49 4207 4208 +7901 49 4210 4211 +7902 49 4213 4214 +7903 49 4216 4217 +7904 49 4219 4220 +7905 49 4222 4223 +7906 49 4225 4226 +7907 49 4228 4229 +7908 49 4231 4232 +7909 49 4234 4235 +7910 49 4237 4238 +7911 49 4240 4241 +7912 49 4243 4244 +7913 49 4246 4247 +7914 49 4249 4250 +7915 49 4252 4253 +7916 49 4255 4256 +7917 49 4258 4259 +7918 49 4261 4262 +7919 49 4264 4265 +7920 49 4267 4268 +7921 49 4270 4271 +7922 49 4273 4274 +7923 49 4276 4277 +7924 49 4279 4280 +7925 49 4282 4283 +7926 49 4285 4286 +7927 49 4288 4289 +7928 49 4291 4292 +7929 49 4294 4295 +7930 49 4297 4298 +7931 49 4300 4301 +7932 49 4303 4304 +7933 49 4306 4307 +7934 49 4309 4310 +7935 49 4312 4313 +7936 49 4315 4316 +7937 49 4318 4319 +7938 49 4321 4322 +7939 49 4324 4325 +7940 49 4327 4328 +7941 49 4330 4331 +7942 49 4333 4334 +7943 49 4336 4337 +7944 49 4339 4340 +7945 49 4342 4343 +7946 49 4345 4346 +7947 49 4348 4349 +7948 49 4351 4352 +7949 49 4354 4355 +7950 49 4357 4358 +7951 49 4360 4361 +7952 49 4363 4364 +7953 49 4366 4367 +7954 49 4369 4370 +7955 49 4372 4373 +7956 49 4375 4376 +7957 49 4378 4379 +7958 49 4381 4382 +7959 49 4384 4385 +7960 49 4387 4388 +7961 49 4390 4391 +7962 49 4393 4394 +7963 49 4396 4397 +7964 49 4399 4400 +7965 49 4402 4403 +7966 49 4405 4406 +7967 49 4408 4409 +7968 49 4411 4412 +7969 49 4414 4415 +7970 49 4417 4418 +7971 49 4420 4421 +7972 49 4423 4424 +7973 49 4426 4427 +7974 49 4429 4430 +7975 49 4432 4433 +7976 49 4435 4436 +7977 49 4438 4439 +7978 49 4441 4442 +7979 49 4444 4445 +7980 49 4447 4448 +7981 49 4450 4451 +7982 49 4453 4454 +7983 49 4456 4457 +7984 49 4459 4460 +7985 49 4462 4463 +7986 49 4465 4466 +7987 49 4468 4469 +7988 49 4471 4472 +7989 49 4474 4475 +7990 49 4477 4478 +7991 49 4480 4481 +7992 49 4483 4484 +7993 49 4486 4487 +7994 49 4489 4490 +7995 49 4492 4493 +7996 49 4495 4496 +7997 49 4498 4499 +7998 49 4501 4502 +7999 49 4504 4505 +8000 49 4507 4508 +8001 49 4510 4511 +8002 49 4513 4514 +8003 49 4516 4517 +8004 49 4519 4520 +8005 49 4522 4523 +8006 49 4525 4526 +8007 49 4528 4529 +8008 49 4531 4532 +8009 49 4534 4535 +8010 49 4537 4538 +8011 49 4540 4541 +8012 49 4543 4544 +8013 49 4546 4547 +8014 49 4549 4550 +8015 49 4552 4553 +8016 49 4555 4556 +8017 49 4558 4559 +8018 49 4561 4562 +8019 49 4564 4565 +8020 49 4567 4568 +8021 49 4570 4571 +8022 49 4573 4574 +8023 49 4576 4577 +8024 49 4579 4580 +8025 49 4582 4583 +8026 49 4585 4586 +8027 49 4588 4589 +8028 49 4591 4592 +8029 49 4594 4595 +8030 49 4597 4598 +8031 49 4600 4601 +8032 49 4603 4604 +8033 49 4606 4607 +8034 49 4609 4610 +8035 49 4612 4613 +8036 49 4615 4616 +8037 49 4618 4619 +8038 49 4621 4622 +8039 49 4624 4625 +8040 49 4627 4628 +8041 49 4630 4631 +8042 49 4633 4634 +8043 49 4636 4637 +8044 49 4639 4640 +8045 49 4642 4643 +8046 49 4645 4646 +8047 49 4648 4649 +8048 49 4651 4652 +8049 49 4654 4655 +8050 49 4657 4658 +8051 49 4660 4661 +8052 49 4663 4664 +8053 49 4666 4667 +8054 49 4669 4670 +8055 49 4672 4673 +8056 49 4675 4676 +8057 49 4678 4679 +8058 49 4681 4682 +8059 49 4684 4685 +8060 49 4687 4688 +8061 49 4690 4691 +8062 49 4693 4694 +8063 49 4696 4697 +8064 49 4699 4700 +8065 49 4702 4703 +8066 49 4705 4706 +8067 49 4708 4709 +8068 49 4711 4712 +8069 49 4714 4715 +8070 49 4717 4718 +8071 49 4720 4721 +8072 49 4723 4724 +8073 49 4726 4727 +8074 49 4729 4730 +8075 49 4732 4733 +8076 49 4735 4736 +8077 49 4738 4739 +8078 49 4741 4742 +8079 49 4744 4745 +8080 49 4747 4748 +8081 49 4750 4751 +8082 49 4753 4754 +8083 49 4756 4757 +8084 49 4759 4760 +8085 49 4762 4763 +8086 49 4765 4766 +8087 49 4768 4769 +8088 49 4771 4772 +8089 49 4774 4775 +8090 49 4777 4778 +8091 49 4780 4781 +8092 49 4783 4784 +8093 49 4786 4787 +8094 49 4789 4790 +8095 49 4792 4793 +8096 49 4795 4796 +8097 49 4798 4799 +8098 49 4801 4802 +8099 49 4804 4805 +8100 49 4807 4808 +8101 49 4810 4811 +8102 49 4813 4814 +8103 49 4816 4817 +8104 49 4819 4820 +8105 49 4822 4823 +8106 49 4825 4826 +8107 49 4828 4829 +8108 49 4831 4832 +8109 49 4834 4835 +8110 49 4837 4838 +8111 49 4840 4841 +8112 49 4843 4844 +8113 49 4846 4847 +8114 49 4849 4850 +8115 49 4852 4853 +8116 49 4855 4856 +8117 49 4858 4859 +8118 49 4861 4862 +8119 49 4864 4865 +8120 49 4867 4868 +8121 49 4870 4871 +8122 49 4873 4874 +8123 49 4876 4877 +8124 49 4879 4880 +8125 49 4882 4883 +8126 49 4885 4886 +8127 49 4888 4889 +8128 49 4891 4892 +8129 49 4894 4895 +8130 49 4897 4898 +8131 49 4900 4901 +8132 49 4903 4904 +8133 49 4906 4907 +8134 49 4909 4910 +8135 49 4912 4913 +8136 49 4915 4916 +8137 49 4918 4919 +8138 49 4921 4922 +8139 49 4924 4925 +8140 49 4927 4928 +8141 49 4930 4931 +8142 49 4933 4934 +8143 49 4936 4937 +8144 49 4939 4940 +8145 49 4942 4943 +8146 49 4945 4946 +8147 49 4948 4949 +8148 49 4951 4952 +8149 49 4954 4955 +8150 49 4957 4958 +8151 49 4960 4961 +8152 49 4963 4964 +8153 49 4966 4967 +8154 49 4969 4970 +8155 49 4972 4973 +8156 49 4975 4976 +8157 49 4978 4979 +8158 49 4981 4982 +8159 49 4984 4985 +8160 49 4987 4988 +8161 49 4990 4991 +8162 49 4993 4994 +8163 49 4996 4997 +8164 49 4999 5000 +8165 49 5002 5003 +8166 49 5005 5006 +8167 49 5008 5009 +8168 49 5011 5012 +8169 49 5014 5015 +8170 49 5017 5018 +8171 49 5020 5021 +8172 49 5023 5024 +8173 49 5026 5027 +8174 49 5029 5030 +8175 49 5032 5033 +8176 49 5035 5036 +8177 49 5038 5039 +8178 49 5041 5042 +8179 49 5044 5045 +8180 49 5047 5048 +8181 49 5050 5051 +8182 49 5053 5054 +8183 49 5056 5057 +8184 49 5059 5060 +8185 49 5062 5063 +8186 49 5065 5066 +8187 49 5068 5069 +8188 49 5071 5072 +8189 49 5074 5075 +8190 49 5077 5078 +8191 49 5080 5081 +8192 49 5083 5084 +8193 49 5086 5087 +8194 49 5089 5090 +8195 49 5092 5093 +8196 49 5095 5096 +8197 49 5098 5099 +8198 49 5101 5102 +8199 49 5104 5105 +8200 49 5107 5108 +8201 49 5110 5111 +8202 49 5113 5114 +8203 49 5116 5117 +8204 49 5119 5120 +8205 49 5122 5123 +8206 49 5125 5126 +8207 49 5128 5129 +8208 49 5131 5132 +8209 49 5134 5135 +8210 49 5137 5138 +8211 49 5140 5141 +8212 49 5143 5144 +8213 49 5146 5147 +8214 49 5149 5150 +8215 49 5152 5153 +8216 49 5155 5156 +8217 49 5158 5159 +8218 49 5161 5162 +8219 49 5164 5165 +8220 49 5167 5168 +8221 49 5170 5171 +8222 49 5173 5174 +8223 49 5176 5177 +8224 49 5179 5180 +8225 49 5182 5183 +8226 49 5185 5186 +8227 49 5188 5189 +8228 49 5191 5192 +8229 49 5194 5195 +8230 49 5197 5198 +8231 49 5200 5201 +8232 49 5203 5204 +8233 49 5206 5207 +8234 49 5209 5210 +8235 49 5212 5213 +8236 49 5215 5216 +8237 49 5218 5219 +8238 49 5221 5222 +8239 49 5224 5225 +8240 49 5227 5228 +8241 49 5230 5231 +8242 49 5233 5234 +8243 49 5236 5237 +8244 49 5239 5240 +8245 49 5242 5243 +8246 49 5245 5246 +8247 49 5248 5249 +8248 49 5251 5252 +8249 49 5254 5255 +8250 49 5257 5258 +8251 49 5260 5261 +8252 49 5263 5264 +8253 49 5266 5267 +8254 49 5269 5270 +8255 49 5272 5273 +8256 49 5275 5276 +8257 49 5278 5279 +8258 49 5281 5282 +8259 49 5284 5285 +8260 49 5287 5288 +8261 49 5290 5291 +8262 49 5293 5294 +8263 49 5296 5297 +8264 49 5299 5300 +8265 49 5302 5303 +8266 49 5305 5306 +8267 49 5308 5309 +8268 49 5311 5312 +8269 49 5314 5315 +8270 49 5317 5318 +8271 49 5320 5321 +8272 49 5323 5324 +8273 49 5326 5327 +8274 49 5329 5330 +8275 49 5332 5333 +8276 49 5335 5336 +8277 49 5338 5339 +8278 49 5341 5342 +8279 49 5344 5345 +8280 49 5347 5348 +8281 49 5350 5351 +8282 49 5353 5354 +8283 49 5356 5357 +8284 49 5359 5360 +8285 49 5362 5363 +8286 49 5365 5366 +8287 49 5368 5369 +8288 49 5371 5372 +8289 49 5374 5375 +8290 49 5377 5378 +8291 49 5380 5381 +8292 49 5383 5384 +8293 49 5386 5387 +8294 49 5389 5390 +8295 49 5392 5393 +8296 49 5395 5396 +8297 49 5398 5399 +8298 49 5401 5402 +8299 49 5404 5405 +8300 49 5407 5408 +8301 49 5410 5411 +8302 49 5413 5414 +8303 49 5416 5417 +8304 49 5419 5420 +8305 49 5422 5423 +8306 49 5425 5426 +8307 49 5428 5429 +8308 49 5431 5432 +8309 49 5434 5435 +8310 49 5437 5438 +8311 49 5440 5441 +8312 49 5443 5444 +8313 49 5446 5447 +8314 49 5449 5450 +8315 49 5452 5453 +8316 49 5455 5456 +8317 49 5458 5459 +8318 49 5461 5462 +8319 49 5464 5465 +8320 49 5467 5468 +8321 49 5470 5471 +8322 49 5473 5474 +8323 49 5476 5477 +8324 49 5479 5480 +8325 49 5482 5483 +8326 49 5485 5486 +8327 49 5488 5489 +8328 49 5491 5492 +8329 49 5494 5495 +8330 49 5497 5498 +8331 49 5500 5501 +8332 49 5503 5504 +8333 49 5506 5507 +8334 49 5509 5510 +8335 49 5512 5513 +8336 49 5515 5516 +8337 49 5518 5519 +8338 49 5521 5522 +8339 49 5524 5525 +8340 49 5527 5528 +8341 49 5530 5531 +8342 49 5533 5534 +8343 49 5536 5537 +8344 49 5539 5540 +8345 49 5542 5543 +8346 49 5545 5546 +8347 49 5548 5549 +8348 49 5551 5552 +8349 49 5554 5555 +8350 49 5557 5558 +8351 49 5560 5561 +8352 49 5563 5564 +8353 49 5566 5567 +8354 49 5569 5570 +8355 49 5572 5573 +8356 49 5575 5576 +8357 49 5578 5579 +8358 49 5581 5582 +8359 49 5584 5585 +8360 49 5587 5588 +8361 49 5590 5591 +8362 49 5593 5594 +8363 49 5596 5597 +8364 49 5599 5600 +8365 49 5602 5603 +8366 49 5605 5606 +8367 49 5608 5609 +8368 49 5611 5612 +8369 49 5614 5615 +8370 49 5617 5618 +8371 49 5620 5621 +8372 49 5623 5624 +8373 49 5626 5627 +8374 49 5629 5630 +8375 49 5632 5633 +8376 49 5635 5636 +8377 49 5638 5639 +8378 49 5641 5642 +8379 49 5644 5645 +8380 49 5647 5648 +8381 49 5650 5651 +8382 49 5653 5654 +8383 49 5656 5657 +8384 49 5659 5660 +8385 49 5662 5663 +8386 49 5665 5666 +8387 49 5668 5669 +8388 49 5671 5672 +8389 49 5674 5675 +8390 49 5677 5678 +8391 49 5680 5681 +8392 49 5683 5684 +8393 49 5686 5687 +8394 49 5689 5690 +8395 49 5692 5693 +8396 49 5695 5696 +8397 49 5698 5699 +8398 49 5701 5702 +8399 49 5704 5705 +8400 49 5707 5708 +8401 49 5710 5711 +8402 49 5713 5714 +8403 49 5716 5717 +8404 49 5719 5720 +8405 49 5722 5723 +8406 49 5725 5726 +8407 49 5728 5729 +8408 49 5731 5732 +8409 49 5734 5735 +8410 49 5737 5738 +8411 49 5740 5741 +8412 49 5743 5744 +8413 49 5746 5747 +8414 49 5749 5750 +8415 49 5752 5753 +8416 49 5755 5756 +8417 49 5758 5759 +8418 49 5761 5762 +8419 49 5764 5765 +8420 49 5767 5768 +8421 49 5770 5771 +8422 49 5773 5774 +8423 49 5776 5777 +8424 49 5779 5780 +8425 49 5782 5783 +8426 49 5785 5786 +8427 49 5788 5789 +8428 49 5791 5792 +8429 49 5794 5795 +8430 49 5797 5798 +8431 49 5800 5801 +8432 49 5803 5804 +8433 49 5806 5807 +8434 49 5809 5810 +8435 49 5812 5813 +8436 49 5815 5816 +8437 49 5818 5819 +8438 49 5821 5822 +8439 49 5824 5825 +8440 49 5827 5828 +8441 49 5830 5831 +8442 49 5833 5834 +8443 49 5836 5837 +8444 49 5839 5840 +8445 49 5842 5843 +8446 49 5845 5846 +8447 49 5848 5849 +8448 49 5851 5852 +8449 49 5854 5855 +8450 49 5857 5858 +8451 49 5860 5861 +8452 49 5863 5864 +8453 49 5866 5867 +8454 49 5869 5870 +8455 49 5872 5873 +8456 49 5875 5876 +8457 49 5878 5879 +8458 49 5881 5882 +8459 49 5884 5885 +8460 49 5887 5888 +8461 49 5890 5891 +8462 49 5893 5894 +8463 49 5896 5897 +8464 49 5899 5900 +8465 49 5902 5903 +8466 49 5905 5906 +8467 49 5908 5909 +8468 49 5911 5912 +8469 49 5914 5915 +8470 49 5917 5918 +8471 49 5920 5921 +8472 49 5923 5924 +8473 49 5926 5927 +8474 49 5929 5930 +8475 49 5932 5933 +8476 49 5935 5936 +8477 49 5938 5939 +8478 49 5941 5942 +8479 49 5944 5945 +8480 49 5947 5948 +8481 49 5950 5951 +8482 49 5953 5954 +8483 49 5956 5957 +8484 49 5959 5960 +8485 49 5962 5963 +8486 49 5965 5966 +8487 49 5968 5969 +8488 49 5971 5972 +8489 49 5974 5975 +8490 49 5977 5978 +8491 49 5980 5981 +8492 49 5983 5984 +8493 49 5986 5987 +8494 49 5989 5990 +8495 49 5992 5993 +8496 49 5995 5996 +8497 49 5998 5999 +8498 49 6001 6002 +8499 49 6004 6005 +8500 49 6007 6008 +8501 49 6010 6011 +8502 49 6013 6014 +8503 49 6016 6017 +8504 49 6019 6020 +8505 49 6022 6023 +8506 49 6025 6026 +8507 49 6028 6029 +8508 49 6031 6032 +8509 49 6034 6035 +8510 49 6037 6038 +8511 49 6040 6041 +8512 49 6043 6044 +8513 49 6046 6047 +8514 49 6049 6050 +8515 49 6052 6053 +8516 49 6055 6056 +8517 49 6058 6059 +8518 49 6061 6062 +8519 49 6064 6065 +8520 49 6067 6068 +8521 49 6070 6071 +8522 49 6073 6074 +8523 49 6076 6077 +8524 49 6079 6080 +8525 49 6082 6083 +8526 49 6085 6086 +8527 49 6088 6089 +8528 49 6091 6092 +8529 49 6094 6095 +8530 49 6097 6098 +8531 49 6100 6101 +8532 49 6103 6104 +8533 49 6106 6107 +8534 49 6109 6110 +8535 49 6112 6113 +8536 49 6115 6116 +8537 49 6118 6119 +8538 49 6121 6122 +8539 49 6124 6125 +8540 49 6127 6128 +8541 49 6130 6131 +8542 49 6133 6134 +8543 49 6136 6137 +8544 49 6139 6140 +8545 49 6142 6143 +8546 49 6145 6146 +8547 49 6148 6149 +8548 49 6151 6152 +8549 49 6154 6155 +8550 49 6157 6158 +8551 49 6160 6161 +8552 49 6163 6164 +8553 49 6166 6167 +8554 49 6169 6170 +8555 49 6172 6173 +8556 49 6175 6176 +8557 49 6178 6179 +8558 49 6181 6182 +8559 49 6184 6185 +8560 49 6187 6188 +8561 49 6190 6191 +8562 49 6193 6194 +8563 49 6196 6197 +8564 49 6199 6200 +8565 49 6202 6203 +8566 49 6205 6206 +8567 49 6208 6209 +8568 49 6211 6212 +8569 49 6214 6215 +8570 49 6217 6218 +8571 49 6220 6221 +8572 49 6223 6224 +8573 49 6226 6227 +8574 49 6229 6230 +8575 49 6232 6233 +8576 49 6235 6236 +8577 49 6238 6239 +8578 49 6241 6242 +8579 49 6244 6245 +8580 49 6247 6248 +8581 49 6250 6251 +8582 49 6253 6254 +8583 49 6256 6257 +8584 49 6259 6260 +8585 49 6262 6263 +8586 49 6265 6266 +8587 49 6268 6269 +8588 49 6271 6272 +8589 49 6274 6275 +8590 49 6277 6278 +8591 49 6280 6281 +8592 49 6283 6284 +8593 49 6286 6287 +8594 49 6289 6290 +8595 49 6292 6293 +8596 49 6295 6296 +8597 49 6298 6299 +8598 49 6301 6302 +8599 49 6304 6305 +8600 49 6307 6308 +8601 49 6310 6311 +8602 49 6313 6314 +8603 49 6316 6317 +8604 49 6319 6320 +8605 49 6322 6323 +8606 49 6325 6326 +8607 49 6328 6329 +8608 49 6331 6332 +8609 49 6334 6335 +8610 49 6337 6338 +8611 49 6340 6341 +8612 49 6343 6344 +8613 49 6346 6347 +8614 49 6349 6350 +8615 49 6352 6353 +8616 49 6355 6356 +8617 49 6358 6359 +8618 49 6361 6362 +8619 49 6364 6365 +8620 49 6367 6368 +8621 49 6370 6371 +8622 49 6373 6374 +8623 49 6376 6377 +8624 49 6379 6380 +8625 49 6382 6383 +8626 49 6385 6386 +8627 49 6388 6389 +8628 49 6391 6392 +8629 49 6394 6395 +8630 49 6397 6398 +8631 49 6400 6401 +8632 49 6403 6404 +8633 49 6406 6407 +8634 49 6409 6410 +8635 49 6412 6413 +8636 49 6415 6416 +8637 49 6418 6419 +8638 49 6421 6422 +8639 49 6424 6425 +8640 49 6427 6428 +8641 49 6430 6431 +8642 49 6433 6434 +8643 49 6436 6437 +8644 49 6439 6440 +8645 49 6442 6443 +8646 49 6445 6446 +8647 49 6448 6449 +8648 49 6451 6452 +8649 49 6454 6455 +8650 49 6457 6458 +8651 49 6460 6461 +8652 49 6463 6464 +8653 49 6466 6467 +8654 49 6469 6470 +8655 49 6472 6473 +8656 49 6475 6476 +8657 49 6478 6479 +8658 49 6481 6482 +8659 49 6484 6485 +8660 49 6487 6488 +8661 49 6490 6491 +8662 49 6493 6494 +8663 49 6496 6497 +8664 49 6499 6500 +8665 49 6502 6503 +8666 49 6505 6506 +8667 49 6508 6509 +8668 49 6511 6512 +8669 49 6514 6515 +8670 49 6517 6518 +8671 49 6520 6521 +8672 49 6523 6524 +8673 49 6526 6527 +8674 49 6529 6530 +8675 49 6532 6533 +8676 49 6535 6536 +8677 49 6538 6539 +8678 49 6541 6542 +8679 49 6544 6545 +8680 49 6547 6548 +8681 49 6550 6551 +8682 49 6553 6554 +8683 49 6556 6557 +8684 49 6559 6560 +8685 49 6562 6563 +8686 49 6565 6566 +8687 49 6568 6569 +8688 49 6571 6572 +8689 49 6574 6575 +8690 49 6577 6578 +8691 49 6580 6581 +8692 49 6583 6584 +8693 49 6586 6587 +8694 49 6589 6590 +8695 49 6592 6593 +8696 49 6595 6596 +8697 49 6598 6599 +8698 49 6601 6602 +8699 49 6604 6605 +8700 49 6607 6608 +8701 49 6610 6611 +8702 49 6613 6614 +8703 49 6616 6617 +8704 49 6619 6620 +8705 49 6622 6623 +8706 49 6625 6626 +8707 49 6628 6629 +8708 49 6631 6632 +8709 49 6634 6635 +8710 49 6637 6638 +8711 49 6640 6641 +8712 49 6643 6644 +8713 49 6646 6647 +8714 49 6649 6650 +8715 49 6652 6653 +8716 49 6655 6656 +8717 49 6658 6659 +8718 49 6661 6662 +8719 49 6664 6665 +8720 49 6667 6668 +8721 49 6670 6671 +8722 49 6673 6674 +8723 49 6676 6677 +8724 49 6679 6680 +8725 49 6682 6683 +8726 49 6685 6686 +8727 49 6688 6689 +8728 49 6691 6692 +8729 49 6694 6695 +8730 49 6697 6698 +8731 49 6700 6701 +8732 49 6703 6704 +8733 49 6706 6707 +8734 49 6709 6710 +8735 49 6712 6713 +8736 49 6715 6716 +8737 49 6718 6719 +8738 49 6721 6722 +8739 49 6724 6725 +8740 49 6727 6728 +8741 49 6730 6731 +8742 49 6733 6734 +8743 49 6736 6737 +8744 49 6739 6740 +8745 49 6742 6743 +8746 49 6745 6746 +8747 49 6748 6749 +8748 49 6751 6752 +8749 49 6754 6755 +8750 49 6757 6758 +8751 49 6760 6761 +8752 49 6763 6764 +8753 49 6766 6767 +8754 49 6769 6770 +8755 49 6772 6773 +8756 49 6775 6776 +8757 49 6778 6779 +8758 49 6781 6782 +8759 49 6784 6785 +8760 49 6787 6788 +8761 49 6790 6791 +8762 49 6793 6794 +8763 49 6796 6797 +8764 49 6799 6800 +8765 49 6802 6803 +8766 49 6805 6806 +8767 49 6808 6809 +8768 49 6811 6812 +8769 49 6814 6815 +8770 49 6817 6818 +8771 49 6820 6821 +8772 49 6823 6824 +8773 49 6826 6827 +8774 49 6829 6830 +8775 49 6832 6833 +8776 49 6835 6836 +8777 49 6838 6839 +8778 49 6841 6842 +8779 49 6844 6845 +8780 49 6847 6848 +8781 49 6850 6851 +8782 49 6853 6854 +8783 49 6856 6857 +8784 49 6859 6860 +8785 49 6862 6863 +8786 49 6865 6866 +8787 49 6868 6869 +8788 49 6871 6872 +8789 49 6874 6875 +8790 49 6877 6878 +8791 49 6880 6881 +8792 49 6883 6884 +8793 49 6886 6887 +8794 49 6889 6890 +8795 49 6892 6893 +8796 49 6895 6896 +8797 49 6898 6899 +8798 49 6901 6902 +8799 49 6904 6905 +8800 49 6907 6908 +8801 49 6910 6911 +8802 49 6913 6914 +8803 49 6916 6917 +8804 49 6919 6920 +8805 49 6922 6923 +8806 49 6925 6926 +8807 49 6928 6929 +8808 49 6931 6932 +8809 49 6934 6935 +8810 49 6937 6938 +8811 49 6940 6941 +8812 49 6943 6944 +8813 49 6946 6947 +8814 49 6949 6950 +8815 49 6952 6953 +8816 49 6955 6956 +8817 49 6958 6959 +8818 49 6961 6962 +8819 49 6964 6965 +8820 49 6967 6968 +8821 49 6970 6971 +8822 49 6973 6974 +8823 49 6976 6977 +8824 49 6979 6980 +8825 49 6982 6983 +8826 49 6985 6986 +8827 49 6988 6989 +8828 49 6991 6992 +8829 49 6994 6995 +8830 49 6997 6998 +8831 49 7000 7001 +8832 49 7003 7004 +8833 49 7006 7007 +8834 49 7009 7010 +8835 49 7012 7013 +8836 49 7015 7016 +8837 49 7018 7019 +8838 49 7021 7022 +8839 49 7024 7025 +8840 49 7027 7028 +8841 49 7030 7031 +8842 49 7033 7034 +8843 49 7036 7037 +8844 49 7039 7040 +8845 49 7042 7043 +8846 49 7045 7046 +8847 49 7048 7049 +8848 49 7051 7052 +8849 49 7054 7055 +8850 49 7057 7058 +8851 49 7060 7061 +8852 49 7063 7064 +8853 49 7066 7067 +8854 49 7069 7070 +8855 49 7072 7073 +8856 49 7075 7076 +8857 49 7078 7079 +8858 49 7081 7082 +8859 49 7084 7085 +8860 49 7087 7088 +8861 49 7090 7091 +8862 49 7093 7094 +8863 49 7096 7097 +8864 49 7099 7100 +8865 49 7102 7103 +8866 49 7105 7106 +8867 49 7108 7109 +8868 49 7111 7112 +8869 49 7114 7115 +8870 49 7117 7118 +8871 49 7120 7121 +8872 49 7123 7124 +8873 49 7126 7127 +8874 49 7129 7130 +8875 49 7132 7133 +8876 49 7135 7136 +8877 49 7138 7139 +8878 49 7141 7142 +8879 49 7144 7145 +8880 49 7147 7148 +8881 49 7150 7151 +8882 49 7153 7154 +8883 49 7156 7157 +8884 49 7159 7160 +8885 49 7162 7163 +8886 49 7165 7166 +8887 49 7168 7169 +8888 49 7171 7172 +8889 49 7174 7175 +8890 49 7177 7178 +8891 49 7180 7181 +8892 49 7183 7184 +8893 49 7186 7187 +8894 49 7189 7190 +8895 49 7192 7193 +8896 49 7195 7196 +8897 49 7198 7199 +8898 49 7201 7202 +8899 49 7204 7205 +8900 49 7207 7208 +8901 49 7210 7211 +8902 49 7213 7214 +8903 49 7216 7217 +8904 49 7219 7220 +8905 49 7222 7223 +8906 49 7225 7226 +8907 49 7228 7229 +8908 49 7231 7232 +8909 49 7234 7235 +8910 49 7237 7238 +8911 49 7240 7241 +8912 49 7243 7244 +8913 49 7246 7247 +8914 49 7249 7250 +8915 49 7252 7253 +8916 49 7255 7256 +8917 49 7258 7259 +8918 49 7261 7262 +8919 49 7264 7265 +8920 49 7267 7268 +8921 49 7270 7271 +8922 49 7273 7274 +8923 49 7276 7277 +8924 49 7279 7280 +8925 49 7282 7283 +8926 49 7285 7286 +8927 49 7288 7289 +8928 49 7291 7292 +8929 49 7294 7295 +8930 49 7297 7298 +8931 49 7300 7301 +8932 49 7303 7304 +8933 49 7306 7307 +8934 49 7309 7310 +8935 49 7312 7313 +8936 49 7315 7316 +8937 49 7318 7319 +8938 49 7321 7322 +8939 49 7324 7325 +8940 49 7327 7328 +8941 49 7330 7331 +8942 49 7333 7334 +8943 49 7336 7337 +8944 49 7339 7340 +8945 49 7342 7343 +8946 49 7345 7346 +8947 49 7348 7349 +8948 49 7351 7352 +8949 49 7354 7355 +8950 49 7357 7358 +8951 49 7360 7361 +8952 49 7363 7364 +8953 49 7366 7367 +8954 49 7369 7370 +8955 49 7372 7373 +8956 49 7375 7376 +8957 49 7378 7379 +8958 49 7381 7382 +8959 49 7384 7385 +8960 49 7387 7388 +8961 49 7390 7391 +8962 49 7393 7394 +8963 49 7396 7397 +8964 49 7399 7400 +8965 49 7402 7403 +8966 49 7405 7406 +8967 49 7408 7409 +8968 49 7411 7412 +8969 49 7414 7415 +8970 49 7417 7418 +8971 49 7420 7421 +8972 49 7423 7424 +8973 49 7426 7427 +8974 49 7429 7430 +8975 49 7432 7433 +8976 49 7435 7436 +8977 49 7438 7439 +8978 49 7441 7442 +8979 49 7444 7445 +8980 49 7447 7448 +8981 49 7450 7451 +8982 49 7453 7454 +8983 49 7456 7457 +8984 49 7459 7460 +8985 49 7462 7463 +8986 49 7465 7466 +8987 49 7468 7469 +8988 49 7471 7472 +8989 49 7474 7475 +8990 49 7477 7478 +8991 49 7480 7481 +8992 49 7483 7484 +8993 49 7486 7487 +8994 49 7489 7490 +8995 49 7492 7493 +8996 49 7495 7496 +8997 49 7498 7499 +8998 49 7501 7502 +8999 49 7504 7505 +9000 49 7507 7508 +9001 49 7510 7511 +9002 49 7513 7514 +9003 49 7516 7517 +9004 49 7519 7520 +9005 49 7522 7523 +9006 49 7525 7526 +9007 49 7528 7529 +9008 49 7531 7532 +9009 49 7534 7535 +9010 49 7537 7538 +9011 49 7540 7541 +9012 49 7543 7544 +9013 49 7546 7547 +9014 49 7549 7550 +9015 49 7552 7553 +9016 49 7555 7556 +9017 49 7558 7559 +9018 49 7561 7562 +9019 49 7564 7565 +9020 49 7567 7568 +9021 49 7570 7571 +9022 49 7573 7574 +9023 49 7576 7577 +9024 49 7579 7580 +9025 49 7582 7583 +9026 49 7585 7586 +9027 49 7588 7589 +9028 49 7591 7592 +9029 49 7594 7595 +9030 49 7597 7598 +9031 49 7600 7601 +9032 49 7603 7604 +9033 49 7606 7607 +9034 49 7609 7610 +9035 49 7612 7613 +9036 49 7615 7616 +9037 49 7618 7619 +9038 49 7621 7622 +9039 49 7624 7625 +9040 49 7627 7628 +9041 49 7630 7631 +9042 49 7633 7634 +9043 49 7636 7637 +9044 49 7639 7640 +9045 49 7642 7643 +9046 49 7645 7646 +9047 49 7648 7649 +9048 49 7651 7652 +9049 49 7654 7655 +9050 49 7657 7658 +9051 49 7660 7661 +9052 49 7663 7664 +9053 49 7666 7667 +9054 49 7669 7670 +9055 49 7672 7673 +9056 49 7675 7676 +9057 49 7678 7679 +9058 49 7681 7682 +9059 49 7684 7685 +9060 49 7687 7688 +9061 49 7690 7691 +9062 49 7693 7694 +9063 49 7696 7697 +9064 49 7699 7700 +9065 49 7702 7703 +9066 49 7705 7706 +9067 49 7708 7709 +9068 49 7711 7712 +9069 49 7714 7715 +9070 49 7717 7718 +9071 49 7720 7721 +9072 49 7723 7724 +9073 49 7726 7727 +9074 49 7729 7730 +9075 49 7732 7733 +9076 49 7735 7736 +9077 49 7738 7739 +9078 49 7741 7742 +9079 49 7744 7745 +9080 49 7747 7748 +9081 49 7750 7751 +9082 49 7753 7754 +9083 49 7756 7757 +9084 49 7759 7760 +9085 49 7762 7763 +9086 49 7765 7766 +9087 49 7768 7769 +9088 49 7771 7772 +9089 49 7774 7775 +9090 49 7777 7778 +9091 49 7780 7781 +9092 49 7783 7784 +9093 49 7786 7787 +9094 49 7789 7790 +9095 49 7792 7793 +9096 49 7795 7796 +9097 49 7798 7799 +9098 49 7801 7802 +9099 49 7804 7805 +9100 49 7807 7808 +9101 49 7810 7811 +9102 49 7813 7814 +9103 49 7816 7817 +9104 49 7819 7820 +9105 49 7822 7823 +9106 49 7825 7826 +9107 49 7828 7829 +9108 49 7831 7832 +9109 49 7834 7835 +9110 49 7837 7838 +9111 49 7840 7841 +9112 49 7843 7844 +9113 49 7846 7847 +9114 49 7849 7850 +9115 49 7852 7853 +9116 49 7855 7856 +9117 49 7858 7859 +9118 49 7861 7862 +9119 49 7864 7865 +9120 49 7867 7868 +9121 49 7870 7871 +9122 49 7873 7874 +9123 49 7876 7877 +9124 49 7879 7880 +9125 49 7882 7883 +9126 49 7885 7886 +9127 49 7888 7889 +9128 49 7891 7892 +9129 49 7894 7895 +9130 49 7897 7898 +9131 49 7900 7901 +9132 49 7903 7904 +9133 49 7906 7907 +9134 49 7909 7910 +9135 49 7912 7913 +9136 49 7915 7916 +9137 49 7918 7919 +9138 49 7921 7922 +9139 49 7924 7925 +9140 49 7927 7928 +9141 49 7930 7931 +9142 49 7933 7934 +9143 49 7936 7937 +9144 49 7939 7940 +9145 49 7942 7943 +9146 49 7945 7946 +9147 49 7948 7949 +9148 49 7951 7952 +9149 49 7954 7955 +9150 49 7957 7958 +9151 49 7960 7961 +9152 49 7963 7964 +9153 49 7966 7967 +9154 49 7969 7970 +9155 49 7972 7973 +9156 49 7975 7976 +9157 49 7978 7979 +9158 49 7981 7982 +9159 49 7984 7985 +9160 49 7987 7988 +9161 49 7990 7991 +9162 49 7993 7994 +9163 49 7996 7997 +9164 49 7999 8000 +9165 49 8002 8003 +9166 49 8005 8006 +9167 49 8008 8009 +9168 49 8011 8012 +9169 49 8014 8015 +9170 49 8017 8018 +9171 49 8020 8021 +9172 49 8023 8024 +9173 49 8026 8027 +9174 49 8029 8030 +9175 49 8032 8033 +9176 49 8035 8036 +9177 49 8038 8039 +9178 49 8041 8042 +9179 49 8044 8045 +9180 49 8047 8048 +9181 49 8050 8051 +9182 49 8053 8054 +9183 49 8056 8057 +9184 49 8059 8060 +9185 49 8062 8063 +9186 49 8065 8066 +9187 49 8068 8069 +9188 49 8071 8072 +9189 49 8074 8075 +9190 49 8077 8078 +9191 49 8080 8081 +9192 49 8083 8084 +9193 49 8086 8087 +9194 49 8089 8090 +9195 49 8092 8093 +9196 49 8095 8096 +9197 49 8098 8099 +9198 49 8101 8102 +9199 49 8104 8105 +9200 49 8107 8108 +9201 49 8110 8111 +9202 49 8113 8114 +9203 49 8116 8117 +9204 49 8119 8120 +9205 49 8122 8123 +9206 49 8125 8126 +9207 49 8128 8129 +9208 49 8131 8132 +9209 49 8134 8135 +9210 49 8137 8138 +9211 49 8140 8141 +9212 49 8143 8144 +9213 49 8146 8147 +9214 49 8149 8150 +9215 49 8152 8153 +9216 49 8155 8156 +9217 49 8158 8159 +9218 49 8161 8162 +9219 49 8164 8165 +9220 49 8167 8168 +9221 49 8170 8171 +9222 49 8173 8174 +9223 49 8176 8177 +9224 49 8179 8180 +9225 49 8182 8183 +9226 49 8185 8186 +9227 49 8188 8189 +9228 49 8191 8192 +9229 49 8194 8195 +9230 49 8197 8198 +9231 49 8200 8201 +9232 49 8203 8204 +9233 49 8206 8207 +9234 49 8209 8210 +9235 49 8212 8213 +9236 49 8215 8216 +9237 49 8218 8219 +9238 49 8221 8222 +9239 49 8224 8225 +9240 49 8227 8228 +9241 49 8230 8231 +9242 49 8233 8234 +9243 49 8236 8237 +9244 49 8239 8240 +9245 49 8242 8243 +9246 49 8245 8246 +9247 49 8248 8249 +9248 49 8251 8252 +9249 49 8254 8255 +9250 49 8257 8258 +9251 49 8260 8261 +9252 49 8263 8264 +9253 49 8266 8267 +9254 49 8269 8270 +9255 49 8272 8273 +9256 49 8275 8276 +9257 49 8278 8279 +9258 49 8281 8282 +9259 49 8284 8285 +9260 49 8287 8288 +9261 49 8290 8291 +9262 49 8293 8294 +9263 49 8296 8297 +9264 49 8299 8300 +9265 49 8302 8303 +9266 49 8305 8306 +9267 49 8308 8309 +9268 49 8311 8312 +9269 49 8314 8315 +9270 49 8317 8318 +9271 49 8320 8321 +9272 49 8323 8324 +9273 49 8326 8327 +9274 49 8329 8330 +9275 49 8332 8333 +9276 49 8335 8336 +9277 49 8338 8339 +9278 49 8341 8342 +9279 49 8344 8345 +9280 49 8347 8348 +9281 49 8350 8351 +9282 49 8353 8354 +9283 49 8356 8357 +9284 49 8359 8360 +9285 49 8362 8363 +9286 49 8365 8366 +9287 49 8368 8369 +9288 49 8371 8372 +9289 49 8374 8375 +9290 49 8377 8378 +9291 49 8380 8381 +9292 49 8383 8384 +9293 49 8386 8387 +9294 49 8389 8390 +9295 49 8392 8393 +9296 49 8395 8396 +9297 49 8398 8399 +9298 49 8401 8402 +9299 49 8404 8405 +9300 49 8407 8408 +9301 49 8410 8411 +9302 49 8413 8414 +9303 49 8416 8417 +9304 49 8419 8420 +9305 49 8422 8423 +9306 49 8425 8426 +9307 49 8428 8429 +9308 49 8431 8432 +9309 49 8434 8435 +9310 49 8437 8438 +9311 49 8440 8441 +9312 49 8443 8444 +9313 49 8446 8447 +9314 49 8449 8450 +9315 49 8452 8453 +9316 49 8455 8456 +9317 49 8458 8459 +9318 49 8461 8462 +9319 49 8464 8465 +9320 49 8467 8468 +9321 49 8470 8471 +9322 49 8473 8474 +9323 49 8476 8477 +9324 49 8479 8480 +9325 49 8482 8483 +9326 49 8485 8486 +9327 49 8488 8489 +9328 49 8491 8492 +9329 49 8494 8495 +9330 49 8497 8498 +9331 49 8500 8501 +9332 49 8503 8504 +9333 49 8506 8507 +9334 49 8509 8510 +9335 49 8512 8513 +9336 49 8515 8516 +9337 49 8518 8519 +9338 49 8521 8522 +9339 49 8524 8525 +9340 49 8527 8528 +9341 49 8530 8531 +9342 49 8533 8534 +9343 49 8536 8537 +9344 49 8539 8540 +9345 49 8542 8543 +9346 49 8545 8546 +9347 49 8548 8549 +9348 49 8551 8552 +9349 49 8554 8555 +9350 49 8557 8558 +9351 49 8560 8561 +9352 49 8563 8564 +9353 49 8566 8567 +9354 49 8569 8570 +9355 49 8572 8573 +9356 49 8575 8576 +9357 49 8578 8579 +9358 49 8581 8582 +9359 49 8584 8585 +9360 49 8587 8588 +9361 49 8590 8591 +9362 49 8593 8594 +9363 49 8596 8597 +9364 49 8599 8600 +9365 49 8602 8603 +9366 49 8605 8606 +9367 49 8608 8609 +9368 49 8611 8612 +9369 49 8614 8615 +9370 49 8617 8618 +9371 49 8620 8621 +9372 49 8623 8624 +9373 49 8626 8627 +9374 49 8629 8630 +9375 49 8632 8633 +9376 49 8635 8636 +9377 49 8638 8639 +9378 49 8641 8642 +9379 49 8644 8645 +9380 49 8647 8648 +9381 49 8650 8651 +9382 49 8653 8654 +9383 49 8656 8657 +9384 49 8659 8660 +9385 49 8662 8663 +9386 49 8665 8666 +9387 49 8668 8669 +9388 49 8671 8672 +9389 49 8674 8675 +9390 49 8677 8678 +9391 49 8680 8681 +9392 49 8683 8684 +9393 49 8686 8687 +9394 49 8689 8690 +9395 49 8692 8693 +9396 49 8695 8696 +9397 49 8698 8699 +9398 49 8701 8702 +9399 49 8704 8705 +9400 49 8707 8708 +9401 49 8710 8711 +9402 49 8713 8714 +9403 49 8716 8717 +9404 49 8719 8720 +9405 49 8722 8723 +9406 49 8725 8726 +9407 49 8728 8729 +9408 49 8731 8732 +9409 49 8734 8735 +9410 49 8737 8738 +9411 49 8740 8741 +9412 49 8743 8744 +9413 49 8746 8747 +9414 49 8749 8750 +9415 49 8752 8753 +9416 49 8755 8756 +9417 49 8758 8759 +9418 49 8761 8762 +9419 49 8764 8765 +9420 49 8767 8768 +9421 49 8770 8771 +9422 49 8773 8774 +9423 49 8776 8777 +9424 49 8779 8780 +9425 49 8782 8783 +9426 49 8785 8786 +9427 49 8788 8789 +9428 49 8791 8792 +9429 49 8794 8795 +9430 49 8797 8798 +9431 49 8800 8801 +9432 49 8803 8804 +9433 49 8806 8807 +9434 49 8809 8810 +9435 49 8812 8813 +9436 49 8815 8816 +9437 49 8818 8819 +9438 49 8821 8822 +9439 49 8824 8825 +9440 49 8827 8828 +9441 49 8830 8831 +9442 49 8833 8834 +9443 49 8836 8837 +9444 49 8839 8840 +9445 49 8842 8843 +9446 49 8845 8846 +9447 49 8848 8849 +9448 49 8851 8852 +9449 49 8854 8855 +9450 49 8857 8858 +9451 49 8860 8861 +9452 49 8863 8864 +9453 49 8866 8867 +9454 49 8869 8870 +9455 49 8872 8873 +9456 49 8875 8876 +9457 49 8878 8879 +9458 49 8881 8882 +9459 49 8884 8885 +9460 49 8887 8888 +9461 49 8890 8891 +9462 49 8893 8894 +9463 49 8896 8897 +9464 49 8899 8900 +9465 49 8902 8903 +9466 49 8905 8906 +9467 49 8908 8909 +9468 49 8911 8912 +9469 49 8914 8915 +9470 49 8917 8918 +9471 49 8920 8921 +9472 49 8923 8924 +9473 49 8926 8927 +9474 49 8929 8930 +9475 49 8932 8933 +9476 49 8935 8936 +9477 49 8938 8939 +9478 49 8941 8942 +9479 49 8944 8945 +9480 49 8947 8948 +9481 49 8950 8951 +9482 49 8953 8954 +9483 49 8956 8957 +9484 49 8959 8960 +9485 49 8962 8963 +9486 49 8965 8966 +9487 49 8968 8969 +9488 49 8971 8972 +9489 49 8974 8975 +9490 49 8977 8978 +9491 49 8980 8981 +9492 49 8983 8984 +9493 49 8986 8987 +9494 49 8989 8990 +9495 49 8992 8993 +9496 49 8995 8996 +9497 49 8998 8999 +9498 49 9001 9002 +9499 49 9004 9005 +9500 49 9007 9008 +9501 49 9010 9011 +9502 49 9013 9014 +9503 49 9016 9017 +9504 49 9019 9020 +9505 49 9022 9023 +9506 49 9025 9026 +9507 49 9028 9029 +9508 49 9031 9032 +9509 49 9034 9035 +9510 49 9037 9038 +9511 49 9040 9041 +9512 49 9043 9044 +9513 49 9046 9047 +9514 49 9049 9050 +9515 49 9052 9053 +9516 49 9055 9056 +9517 49 9058 9059 +9518 49 9061 9062 +9519 49 9064 9065 +9520 49 9067 9068 +9521 49 9070 9071 +9522 49 9073 9074 +9523 49 9076 9077 +9524 49 9079 9080 +9525 49 9082 9083 +9526 49 9085 9086 +9527 49 9088 9089 +9528 49 9091 9092 +9529 49 9094 9095 +9530 49 9097 9098 +9531 49 9100 9101 +9532 49 9103 9104 +9533 49 9106 9107 +9534 49 9109 9110 +9535 49 9112 9113 +9536 49 9115 9116 +9537 49 9118 9119 +9538 49 9121 9122 +9539 49 9124 9125 +9540 49 9127 9128 +9541 49 9130 9131 +9542 49 9133 9134 +9543 49 9136 9137 +9544 49 9139 9140 +9545 49 9142 9143 +9546 49 9145 9146 +9547 49 9148 9149 +9548 49 9151 9152 +9549 49 9154 9155 +9550 49 9157 9158 +9551 49 9160 9161 +9552 49 9163 9164 +9553 49 9166 9167 +9554 49 9169 9170 +9555 49 9172 9173 +9556 49 9175 9176 +9557 49 9178 9179 +9558 49 9181 9182 +9559 49 9184 9185 +9560 49 9187 9188 +9561 49 9190 9191 +9562 49 9193 9194 +9563 49 9196 9197 +9564 49 9199 9200 +9565 49 9202 9203 +9566 49 9205 9206 +9567 49 9208 9209 +9568 49 9211 9212 +9569 49 9214 9215 +9570 49 9217 9218 +9571 49 9220 9221 +9572 49 9223 9224 +9573 49 9226 9227 +9574 49 9229 9230 +9575 49 9232 9233 +9576 49 9235 9236 +9577 49 9238 9239 +9578 49 9241 9242 +9579 49 9244 9245 +9580 49 9247 9248 +9581 49 9250 9251 +9582 49 9253 9254 +9583 49 9256 9257 +9584 49 9259 9260 +9585 49 9262 9263 +9586 49 9265 9266 +9587 49 9268 9269 +9588 49 9271 9272 +9589 49 9274 9275 +9590 49 9277 9278 +9591 49 9280 9281 +9592 49 9283 9284 +9593 49 9286 9287 +9594 49 9289 9290 +9595 49 9292 9293 +9596 49 9295 9296 +9597 49 9298 9299 +9598 49 9301 9302 +9599 49 9304 9305 +9600 49 9307 9308 +9601 49 9310 9311 +9602 49 9313 9314 +9603 49 9316 9317 +9604 49 9319 9320 +9605 49 9322 9323 +9606 49 9325 9326 +9607 49 9328 9329 +9608 49 9331 9332 +9609 49 9334 9335 +9610 49 9337 9338 +9611 49 9340 9341 +9612 49 9343 9344 +9613 49 9346 9347 +9614 49 9349 9350 +9615 49 9352 9353 +9616 49 9355 9356 +9617 49 9358 9359 +9618 49 9361 9362 +9619 49 9364 9365 +9620 49 9367 9368 +9621 49 9370 9371 +9622 49 9373 9374 +9623 49 9376 9377 +9624 49 9379 9380 +9625 49 9382 9383 +9626 49 9385 9386 +9627 49 9388 9389 +9628 49 9391 9392 +9629 49 9394 9395 +9630 49 9397 9398 +9631 49 9400 9401 +9632 49 9403 9404 +9633 49 9406 9407 +9634 49 9409 9410 +9635 49 9412 9413 +9636 49 9415 9416 +9637 49 9418 9419 +9638 49 9421 9422 +9639 49 9424 9425 +9640 49 9427 9428 +9641 49 9430 9431 +9642 49 9433 9434 +9643 49 9436 9437 +9644 49 9439 9440 +9645 49 9442 9443 +9646 49 9445 9446 +9647 49 9448 9449 +9648 49 9451 9452 +9649 49 9454 9455 +9650 49 9457 9458 +9651 49 9460 9461 +9652 49 9463 9464 +9653 49 9466 9467 +9654 49 9469 9470 +9655 49 9472 9473 +9656 49 9475 9476 +9657 49 9478 9479 +9658 49 9481 9482 +9659 49 9484 9485 +9660 49 9487 9488 +9661 49 9490 9491 +9662 49 9493 9494 +9663 49 9496 9497 +9664 49 9499 9500 +9665 49 9502 9503 +9666 49 9505 9506 +9667 49 9508 9509 +9668 49 9511 9512 +9669 49 9514 9515 +9670 49 9517 9518 +9671 49 9520 9521 +9672 49 9523 9524 +9673 49 9526 9527 +9674 49 9529 9530 +9675 49 9532 9533 +9676 49 9535 9536 +9677 49 9538 9539 +9678 49 9541 9542 +9679 49 9544 9545 +9680 49 9547 9548 +9681 49 9550 9551 +9682 49 9553 9554 +9683 49 9556 9557 +9684 49 9559 9560 +9685 49 9562 9563 +9686 49 9565 9566 +9687 49 9568 9569 +9688 49 9571 9572 +9689 49 9574 9575 +9690 49 9577 9578 +9691 49 9580 9581 +9692 49 9583 9584 +9693 49 9586 9587 +9694 49 9589 9590 +9695 49 9592 9593 +9696 49 9595 9596 +9697 49 9598 9599 +9698 49 9601 9602 +9699 49 9604 9605 +9700 49 9607 9608 +9701 49 9610 9611 +9702 49 9613 9614 +9703 49 9616 9617 +9704 49 9619 9620 +9705 49 9622 9623 +9706 49 9625 9626 +9707 49 9628 9629 +9708 49 9631 9632 +9709 49 9634 9635 +9710 49 9637 9638 +9711 49 9640 9641 +9712 49 9643 9644 +9713 49 9646 9647 +9714 49 9649 9650 +9715 49 9652 9653 +9716 49 9655 9656 +9717 49 9658 9659 +9718 49 9661 9662 +9719 49 9664 9665 +9720 49 9667 9668 +9721 49 9670 9671 +9722 49 9673 9674 +9723 49 9676 9677 +9724 49 9679 9680 +9725 49 9682 9683 +9726 49 9685 9686 +9727 49 9688 9689 +9728 49 9691 9692 +9729 49 9694 9695 +9730 49 9697 9698 +9731 49 9700 9701 +9732 49 9703 9704 +9733 49 9706 9707 +9734 49 9709 9710 +9735 49 9712 9713 +9736 49 9715 9716 +9737 49 9718 9719 +9738 49 9721 9722 +9739 49 9724 9725 +9740 49 9727 9728 +9741 49 9730 9731 +9742 49 9733 9734 +9743 49 9736 9737 Angles diff --git a/examples/amoeba/in.ubiquitin b/examples/amoeba/in.ubiquitin index 36a455c149..0d7a708826 100644 --- a/examples/amoeba/in.ubiquitin +++ b/examples/amoeba/in.ubiquitin @@ -14,14 +14,15 @@ improper_style amoeba # per-atom properties required by AMOEBA or HIPPO fix amtype all property/atom i_amtype ghost yes -fix pitorsion all pitorsion +#fix pitorsion all pitorsion fix extra all property/atom & i_amgroup i_ired i_xaxis i_yaxis i_zaxis d_pval ghost yes fix extra2 all property/atom i_polaxe -read_data data.ubiquitin fix amtype NULL "Tinker Types" & - fix pitorsion pitorsions PiTorsions +read_data data.ubiquitin fix amtype NULL "Tinker Types" +#read_data data.ubiquitin fix amtype NULL "Tinker Types" & +# fix pitorsion pitorsions PiTorsions pair_style amoeba pair_coeff * * amoeba_ubiquitin.prm amoeba_ubiquitin.key diff --git a/tools/tinker/tinker2lmp.py b/tools/tinker/tinker2lmp.py index 6d867673f9..ba7008e4ea 100644 --- a/tools/tinker/tinker2lmp.py +++ b/tools/tinker/tinker2lmp.py @@ -782,10 +782,10 @@ for atom1,atom2,atom3 in ublist: if (c1,c2,c3) in ubdict: m,params = ubdict[(c1,c2,c3)] - blist.append((c1,c3)) + blist.append((atom1,atom3)) elif (c3,c2,c1) in ubdict: m,params = ubdict[(c3,c2,c1)] - blist.append((c3,c1)) + blist.append((atom3,atom1)) if not flags[m]: v1,v2,v3,v4 = params[3:] From 64becd56422cba2f2e8e78728763d6d361a637ed Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Tue, 8 Mar 2022 13:28:11 -0700 Subject: [PATCH 076/585] move UB bonds to angle amoeba --- examples/amoeba/data.ubiquitin | 3176 +-- examples/amoeba/data.ubiquitin.ub | 29069 ++++++++++++++++++++++++++++ src/AMOEBA/angle_amoeba.cpp | 373 +- src/AMOEBA/angle_amoeba.h | 6 +- tools/tinker/data.py | 1 + tools/tinker/tinker2lmp.py | 122 +- 6 files changed, 29612 insertions(+), 3135 deletions(-) create mode 100644 examples/amoeba/data.ubiquitin.ub diff --git a/examples/amoeba/data.ubiquitin b/examples/amoeba/data.ubiquitin index 361291cdd4..319aadf8ec 100644 --- a/examples/amoeba/data.ubiquitin +++ b/examples/amoeba/data.ubiquitin @@ -1,12 +1,12 @@ LAMMPS data file created from Tinker ubiquitin.xyz and amoeba_ubiquitin.prm files 9737 atoms -9743 bonds +6908 bonds 5094 angles 3297 dihedrals 651 impropers 6 atom types -49 bond types +48 bond types 111 angle types 189 dihedral types 33 improper types @@ -16673,2841 +16673,6 @@ Bonds 6906 48 9732 9734 6907 48 9735 9736 6908 48 9735 9737 -6909 49 1234 1235 -6910 49 1237 1238 -6911 49 1240 1241 -6912 49 1243 1244 -6913 49 1246 1247 -6914 49 1249 1250 -6915 49 1252 1253 -6916 49 1255 1256 -6917 49 1258 1259 -6918 49 1261 1262 -6919 49 1264 1265 -6920 49 1267 1268 -6921 49 1270 1271 -6922 49 1273 1274 -6923 49 1276 1277 -6924 49 1279 1280 -6925 49 1282 1283 -6926 49 1285 1286 -6927 49 1288 1289 -6928 49 1291 1292 -6929 49 1294 1295 -6930 49 1297 1298 -6931 49 1300 1301 -6932 49 1303 1304 -6933 49 1306 1307 -6934 49 1309 1310 -6935 49 1312 1313 -6936 49 1315 1316 -6937 49 1318 1319 -6938 49 1321 1322 -6939 49 1324 1325 -6940 49 1327 1328 -6941 49 1330 1331 -6942 49 1333 1334 -6943 49 1336 1337 -6944 49 1339 1340 -6945 49 1342 1343 -6946 49 1345 1346 -6947 49 1348 1349 -6948 49 1351 1352 -6949 49 1354 1355 -6950 49 1357 1358 -6951 49 1360 1361 -6952 49 1363 1364 -6953 49 1366 1367 -6954 49 1369 1370 -6955 49 1372 1373 -6956 49 1375 1376 -6957 49 1378 1379 -6958 49 1381 1382 -6959 49 1384 1385 -6960 49 1387 1388 -6961 49 1390 1391 -6962 49 1393 1394 -6963 49 1396 1397 -6964 49 1399 1400 -6965 49 1402 1403 -6966 49 1405 1406 -6967 49 1408 1409 -6968 49 1411 1412 -6969 49 1414 1415 -6970 49 1417 1418 -6971 49 1420 1421 -6972 49 1423 1424 -6973 49 1426 1427 -6974 49 1429 1430 -6975 49 1432 1433 -6976 49 1435 1436 -6977 49 1438 1439 -6978 49 1441 1442 -6979 49 1444 1445 -6980 49 1447 1448 -6981 49 1450 1451 -6982 49 1453 1454 -6983 49 1456 1457 -6984 49 1459 1460 -6985 49 1462 1463 -6986 49 1465 1466 -6987 49 1468 1469 -6988 49 1471 1472 -6989 49 1474 1475 -6990 49 1477 1478 -6991 49 1480 1481 -6992 49 1483 1484 -6993 49 1486 1487 -6994 49 1489 1490 -6995 49 1492 1493 -6996 49 1495 1496 -6997 49 1498 1499 -6998 49 1501 1502 -6999 49 1504 1505 -7000 49 1507 1508 -7001 49 1510 1511 -7002 49 1513 1514 -7003 49 1516 1517 -7004 49 1519 1520 -7005 49 1522 1523 -7006 49 1525 1526 -7007 49 1528 1529 -7008 49 1531 1532 -7009 49 1534 1535 -7010 49 1537 1538 -7011 49 1540 1541 -7012 49 1543 1544 -7013 49 1546 1547 -7014 49 1549 1550 -7015 49 1552 1553 -7016 49 1555 1556 -7017 49 1558 1559 -7018 49 1561 1562 -7019 49 1564 1565 -7020 49 1567 1568 -7021 49 1570 1571 -7022 49 1573 1574 -7023 49 1576 1577 -7024 49 1579 1580 -7025 49 1582 1583 -7026 49 1585 1586 -7027 49 1588 1589 -7028 49 1591 1592 -7029 49 1594 1595 -7030 49 1597 1598 -7031 49 1600 1601 -7032 49 1603 1604 -7033 49 1606 1607 -7034 49 1609 1610 -7035 49 1612 1613 -7036 49 1615 1616 -7037 49 1618 1619 -7038 49 1621 1622 -7039 49 1624 1625 -7040 49 1627 1628 -7041 49 1630 1631 -7042 49 1633 1634 -7043 49 1636 1637 -7044 49 1639 1640 -7045 49 1642 1643 -7046 49 1645 1646 -7047 49 1648 1649 -7048 49 1651 1652 -7049 49 1654 1655 -7050 49 1657 1658 -7051 49 1660 1661 -7052 49 1663 1664 -7053 49 1666 1667 -7054 49 1669 1670 -7055 49 1672 1673 -7056 49 1675 1676 -7057 49 1678 1679 -7058 49 1681 1682 -7059 49 1684 1685 -7060 49 1687 1688 -7061 49 1690 1691 -7062 49 1693 1694 -7063 49 1696 1697 -7064 49 1699 1700 -7065 49 1702 1703 -7066 49 1705 1706 -7067 49 1708 1709 -7068 49 1711 1712 -7069 49 1714 1715 -7070 49 1717 1718 -7071 49 1720 1721 -7072 49 1723 1724 -7073 49 1726 1727 -7074 49 1729 1730 -7075 49 1732 1733 -7076 49 1735 1736 -7077 49 1738 1739 -7078 49 1741 1742 -7079 49 1744 1745 -7080 49 1747 1748 -7081 49 1750 1751 -7082 49 1753 1754 -7083 49 1756 1757 -7084 49 1759 1760 -7085 49 1762 1763 -7086 49 1765 1766 -7087 49 1768 1769 -7088 49 1771 1772 -7089 49 1774 1775 -7090 49 1777 1778 -7091 49 1780 1781 -7092 49 1783 1784 -7093 49 1786 1787 -7094 49 1789 1790 -7095 49 1792 1793 -7096 49 1795 1796 -7097 49 1798 1799 -7098 49 1801 1802 -7099 49 1804 1805 -7100 49 1807 1808 -7101 49 1810 1811 -7102 49 1813 1814 -7103 49 1816 1817 -7104 49 1819 1820 -7105 49 1822 1823 -7106 49 1825 1826 -7107 49 1828 1829 -7108 49 1831 1832 -7109 49 1834 1835 -7110 49 1837 1838 -7111 49 1840 1841 -7112 49 1843 1844 -7113 49 1846 1847 -7114 49 1849 1850 -7115 49 1852 1853 -7116 49 1855 1856 -7117 49 1858 1859 -7118 49 1861 1862 -7119 49 1864 1865 -7120 49 1867 1868 -7121 49 1870 1871 -7122 49 1873 1874 -7123 49 1876 1877 -7124 49 1879 1880 -7125 49 1882 1883 -7126 49 1885 1886 -7127 49 1888 1889 -7128 49 1891 1892 -7129 49 1894 1895 -7130 49 1897 1898 -7131 49 1900 1901 -7132 49 1903 1904 -7133 49 1906 1907 -7134 49 1909 1910 -7135 49 1912 1913 -7136 49 1915 1916 -7137 49 1918 1919 -7138 49 1921 1922 -7139 49 1924 1925 -7140 49 1927 1928 -7141 49 1930 1931 -7142 49 1933 1934 -7143 49 1936 1937 -7144 49 1939 1940 -7145 49 1942 1943 -7146 49 1945 1946 -7147 49 1948 1949 -7148 49 1951 1952 -7149 49 1954 1955 -7150 49 1957 1958 -7151 49 1960 1961 -7152 49 1963 1964 -7153 49 1966 1967 -7154 49 1969 1970 -7155 49 1972 1973 -7156 49 1975 1976 -7157 49 1978 1979 -7158 49 1981 1982 -7159 49 1984 1985 -7160 49 1987 1988 -7161 49 1990 1991 -7162 49 1993 1994 -7163 49 1996 1997 -7164 49 1999 2000 -7165 49 2002 2003 -7166 49 2005 2006 -7167 49 2008 2009 -7168 49 2011 2012 -7169 49 2014 2015 -7170 49 2017 2018 -7171 49 2020 2021 -7172 49 2023 2024 -7173 49 2026 2027 -7174 49 2029 2030 -7175 49 2032 2033 -7176 49 2035 2036 -7177 49 2038 2039 -7178 49 2041 2042 -7179 49 2044 2045 -7180 49 2047 2048 -7181 49 2050 2051 -7182 49 2053 2054 -7183 49 2056 2057 -7184 49 2059 2060 -7185 49 2062 2063 -7186 49 2065 2066 -7187 49 2068 2069 -7188 49 2071 2072 -7189 49 2074 2075 -7190 49 2077 2078 -7191 49 2080 2081 -7192 49 2083 2084 -7193 49 2086 2087 -7194 49 2089 2090 -7195 49 2092 2093 -7196 49 2095 2096 -7197 49 2098 2099 -7198 49 2101 2102 -7199 49 2104 2105 -7200 49 2107 2108 -7201 49 2110 2111 -7202 49 2113 2114 -7203 49 2116 2117 -7204 49 2119 2120 -7205 49 2122 2123 -7206 49 2125 2126 -7207 49 2128 2129 -7208 49 2131 2132 -7209 49 2134 2135 -7210 49 2137 2138 -7211 49 2140 2141 -7212 49 2143 2144 -7213 49 2146 2147 -7214 49 2149 2150 -7215 49 2152 2153 -7216 49 2155 2156 -7217 49 2158 2159 -7218 49 2161 2162 -7219 49 2164 2165 -7220 49 2167 2168 -7221 49 2170 2171 -7222 49 2173 2174 -7223 49 2176 2177 -7224 49 2179 2180 -7225 49 2182 2183 -7226 49 2185 2186 -7227 49 2188 2189 -7228 49 2191 2192 -7229 49 2194 2195 -7230 49 2197 2198 -7231 49 2200 2201 -7232 49 2203 2204 -7233 49 2206 2207 -7234 49 2209 2210 -7235 49 2212 2213 -7236 49 2215 2216 -7237 49 2218 2219 -7238 49 2221 2222 -7239 49 2224 2225 -7240 49 2227 2228 -7241 49 2230 2231 -7242 49 2233 2234 -7243 49 2236 2237 -7244 49 2239 2240 -7245 49 2242 2243 -7246 49 2245 2246 -7247 49 2248 2249 -7248 49 2251 2252 -7249 49 2254 2255 -7250 49 2257 2258 -7251 49 2260 2261 -7252 49 2263 2264 -7253 49 2266 2267 -7254 49 2269 2270 -7255 49 2272 2273 -7256 49 2275 2276 -7257 49 2278 2279 -7258 49 2281 2282 -7259 49 2284 2285 -7260 49 2287 2288 -7261 49 2290 2291 -7262 49 2293 2294 -7263 49 2296 2297 -7264 49 2299 2300 -7265 49 2302 2303 -7266 49 2305 2306 -7267 49 2308 2309 -7268 49 2311 2312 -7269 49 2314 2315 -7270 49 2317 2318 -7271 49 2320 2321 -7272 49 2323 2324 -7273 49 2326 2327 -7274 49 2329 2330 -7275 49 2332 2333 -7276 49 2335 2336 -7277 49 2338 2339 -7278 49 2341 2342 -7279 49 2344 2345 -7280 49 2347 2348 -7281 49 2350 2351 -7282 49 2353 2354 -7283 49 2356 2357 -7284 49 2359 2360 -7285 49 2362 2363 -7286 49 2365 2366 -7287 49 2368 2369 -7288 49 2371 2372 -7289 49 2374 2375 -7290 49 2377 2378 -7291 49 2380 2381 -7292 49 2383 2384 -7293 49 2386 2387 -7294 49 2389 2390 -7295 49 2392 2393 -7296 49 2395 2396 -7297 49 2398 2399 -7298 49 2401 2402 -7299 49 2404 2405 -7300 49 2407 2408 -7301 49 2410 2411 -7302 49 2413 2414 -7303 49 2416 2417 -7304 49 2419 2420 -7305 49 2422 2423 -7306 49 2425 2426 -7307 49 2428 2429 -7308 49 2431 2432 -7309 49 2434 2435 -7310 49 2437 2438 -7311 49 2440 2441 -7312 49 2443 2444 -7313 49 2446 2447 -7314 49 2449 2450 -7315 49 2452 2453 -7316 49 2455 2456 -7317 49 2458 2459 -7318 49 2461 2462 -7319 49 2464 2465 -7320 49 2467 2468 -7321 49 2470 2471 -7322 49 2473 2474 -7323 49 2476 2477 -7324 49 2479 2480 -7325 49 2482 2483 -7326 49 2485 2486 -7327 49 2488 2489 -7328 49 2491 2492 -7329 49 2494 2495 -7330 49 2497 2498 -7331 49 2500 2501 -7332 49 2503 2504 -7333 49 2506 2507 -7334 49 2509 2510 -7335 49 2512 2513 -7336 49 2515 2516 -7337 49 2518 2519 -7338 49 2521 2522 -7339 49 2524 2525 -7340 49 2527 2528 -7341 49 2530 2531 -7342 49 2533 2534 -7343 49 2536 2537 -7344 49 2539 2540 -7345 49 2542 2543 -7346 49 2545 2546 -7347 49 2548 2549 -7348 49 2551 2552 -7349 49 2554 2555 -7350 49 2557 2558 -7351 49 2560 2561 -7352 49 2563 2564 -7353 49 2566 2567 -7354 49 2569 2570 -7355 49 2572 2573 -7356 49 2575 2576 -7357 49 2578 2579 -7358 49 2581 2582 -7359 49 2584 2585 -7360 49 2587 2588 -7361 49 2590 2591 -7362 49 2593 2594 -7363 49 2596 2597 -7364 49 2599 2600 -7365 49 2602 2603 -7366 49 2605 2606 -7367 49 2608 2609 -7368 49 2611 2612 -7369 49 2614 2615 -7370 49 2617 2618 -7371 49 2620 2621 -7372 49 2623 2624 -7373 49 2626 2627 -7374 49 2629 2630 -7375 49 2632 2633 -7376 49 2635 2636 -7377 49 2638 2639 -7378 49 2641 2642 -7379 49 2644 2645 -7380 49 2647 2648 -7381 49 2650 2651 -7382 49 2653 2654 -7383 49 2656 2657 -7384 49 2659 2660 -7385 49 2662 2663 -7386 49 2665 2666 -7387 49 2668 2669 -7388 49 2671 2672 -7389 49 2674 2675 -7390 49 2677 2678 -7391 49 2680 2681 -7392 49 2683 2684 -7393 49 2686 2687 -7394 49 2689 2690 -7395 49 2692 2693 -7396 49 2695 2696 -7397 49 2698 2699 -7398 49 2701 2702 -7399 49 2704 2705 -7400 49 2707 2708 -7401 49 2710 2711 -7402 49 2713 2714 -7403 49 2716 2717 -7404 49 2719 2720 -7405 49 2722 2723 -7406 49 2725 2726 -7407 49 2728 2729 -7408 49 2731 2732 -7409 49 2734 2735 -7410 49 2737 2738 -7411 49 2740 2741 -7412 49 2743 2744 -7413 49 2746 2747 -7414 49 2749 2750 -7415 49 2752 2753 -7416 49 2755 2756 -7417 49 2758 2759 -7418 49 2761 2762 -7419 49 2764 2765 -7420 49 2767 2768 -7421 49 2770 2771 -7422 49 2773 2774 -7423 49 2776 2777 -7424 49 2779 2780 -7425 49 2782 2783 -7426 49 2785 2786 -7427 49 2788 2789 -7428 49 2791 2792 -7429 49 2794 2795 -7430 49 2797 2798 -7431 49 2800 2801 -7432 49 2803 2804 -7433 49 2806 2807 -7434 49 2809 2810 -7435 49 2812 2813 -7436 49 2815 2816 -7437 49 2818 2819 -7438 49 2821 2822 -7439 49 2824 2825 -7440 49 2827 2828 -7441 49 2830 2831 -7442 49 2833 2834 -7443 49 2836 2837 -7444 49 2839 2840 -7445 49 2842 2843 -7446 49 2845 2846 -7447 49 2848 2849 -7448 49 2851 2852 -7449 49 2854 2855 -7450 49 2857 2858 -7451 49 2860 2861 -7452 49 2863 2864 -7453 49 2866 2867 -7454 49 2869 2870 -7455 49 2872 2873 -7456 49 2875 2876 -7457 49 2878 2879 -7458 49 2881 2882 -7459 49 2884 2885 -7460 49 2887 2888 -7461 49 2890 2891 -7462 49 2893 2894 -7463 49 2896 2897 -7464 49 2899 2900 -7465 49 2902 2903 -7466 49 2905 2906 -7467 49 2908 2909 -7468 49 2911 2912 -7469 49 2914 2915 -7470 49 2917 2918 -7471 49 2920 2921 -7472 49 2923 2924 -7473 49 2926 2927 -7474 49 2929 2930 -7475 49 2932 2933 -7476 49 2935 2936 -7477 49 2938 2939 -7478 49 2941 2942 -7479 49 2944 2945 -7480 49 2947 2948 -7481 49 2950 2951 -7482 49 2953 2954 -7483 49 2956 2957 -7484 49 2959 2960 -7485 49 2962 2963 -7486 49 2965 2966 -7487 49 2968 2969 -7488 49 2971 2972 -7489 49 2974 2975 -7490 49 2977 2978 -7491 49 2980 2981 -7492 49 2983 2984 -7493 49 2986 2987 -7494 49 2989 2990 -7495 49 2992 2993 -7496 49 2995 2996 -7497 49 2998 2999 -7498 49 3001 3002 -7499 49 3004 3005 -7500 49 3007 3008 -7501 49 3010 3011 -7502 49 3013 3014 -7503 49 3016 3017 -7504 49 3019 3020 -7505 49 3022 3023 -7506 49 3025 3026 -7507 49 3028 3029 -7508 49 3031 3032 -7509 49 3034 3035 -7510 49 3037 3038 -7511 49 3040 3041 -7512 49 3043 3044 -7513 49 3046 3047 -7514 49 3049 3050 -7515 49 3052 3053 -7516 49 3055 3056 -7517 49 3058 3059 -7518 49 3061 3062 -7519 49 3064 3065 -7520 49 3067 3068 -7521 49 3070 3071 -7522 49 3073 3074 -7523 49 3076 3077 -7524 49 3079 3080 -7525 49 3082 3083 -7526 49 3085 3086 -7527 49 3088 3089 -7528 49 3091 3092 -7529 49 3094 3095 -7530 49 3097 3098 -7531 49 3100 3101 -7532 49 3103 3104 -7533 49 3106 3107 -7534 49 3109 3110 -7535 49 3112 3113 -7536 49 3115 3116 -7537 49 3118 3119 -7538 49 3121 3122 -7539 49 3124 3125 -7540 49 3127 3128 -7541 49 3130 3131 -7542 49 3133 3134 -7543 49 3136 3137 -7544 49 3139 3140 -7545 49 3142 3143 -7546 49 3145 3146 -7547 49 3148 3149 -7548 49 3151 3152 -7549 49 3154 3155 -7550 49 3157 3158 -7551 49 3160 3161 -7552 49 3163 3164 -7553 49 3166 3167 -7554 49 3169 3170 -7555 49 3172 3173 -7556 49 3175 3176 -7557 49 3178 3179 -7558 49 3181 3182 -7559 49 3184 3185 -7560 49 3187 3188 -7561 49 3190 3191 -7562 49 3193 3194 -7563 49 3196 3197 -7564 49 3199 3200 -7565 49 3202 3203 -7566 49 3205 3206 -7567 49 3208 3209 -7568 49 3211 3212 -7569 49 3214 3215 -7570 49 3217 3218 -7571 49 3220 3221 -7572 49 3223 3224 -7573 49 3226 3227 -7574 49 3229 3230 -7575 49 3232 3233 -7576 49 3235 3236 -7577 49 3238 3239 -7578 49 3241 3242 -7579 49 3244 3245 -7580 49 3247 3248 -7581 49 3250 3251 -7582 49 3253 3254 -7583 49 3256 3257 -7584 49 3259 3260 -7585 49 3262 3263 -7586 49 3265 3266 -7587 49 3268 3269 -7588 49 3271 3272 -7589 49 3274 3275 -7590 49 3277 3278 -7591 49 3280 3281 -7592 49 3283 3284 -7593 49 3286 3287 -7594 49 3289 3290 -7595 49 3292 3293 -7596 49 3295 3296 -7597 49 3298 3299 -7598 49 3301 3302 -7599 49 3304 3305 -7600 49 3307 3308 -7601 49 3310 3311 -7602 49 3313 3314 -7603 49 3316 3317 -7604 49 3319 3320 -7605 49 3322 3323 -7606 49 3325 3326 -7607 49 3328 3329 -7608 49 3331 3332 -7609 49 3334 3335 -7610 49 3337 3338 -7611 49 3340 3341 -7612 49 3343 3344 -7613 49 3346 3347 -7614 49 3349 3350 -7615 49 3352 3353 -7616 49 3355 3356 -7617 49 3358 3359 -7618 49 3361 3362 -7619 49 3364 3365 -7620 49 3367 3368 -7621 49 3370 3371 -7622 49 3373 3374 -7623 49 3376 3377 -7624 49 3379 3380 -7625 49 3382 3383 -7626 49 3385 3386 -7627 49 3388 3389 -7628 49 3391 3392 -7629 49 3394 3395 -7630 49 3397 3398 -7631 49 3400 3401 -7632 49 3403 3404 -7633 49 3406 3407 -7634 49 3409 3410 -7635 49 3412 3413 -7636 49 3415 3416 -7637 49 3418 3419 -7638 49 3421 3422 -7639 49 3424 3425 -7640 49 3427 3428 -7641 49 3430 3431 -7642 49 3433 3434 -7643 49 3436 3437 -7644 49 3439 3440 -7645 49 3442 3443 -7646 49 3445 3446 -7647 49 3448 3449 -7648 49 3451 3452 -7649 49 3454 3455 -7650 49 3457 3458 -7651 49 3460 3461 -7652 49 3463 3464 -7653 49 3466 3467 -7654 49 3469 3470 -7655 49 3472 3473 -7656 49 3475 3476 -7657 49 3478 3479 -7658 49 3481 3482 -7659 49 3484 3485 -7660 49 3487 3488 -7661 49 3490 3491 -7662 49 3493 3494 -7663 49 3496 3497 -7664 49 3499 3500 -7665 49 3502 3503 -7666 49 3505 3506 -7667 49 3508 3509 -7668 49 3511 3512 -7669 49 3514 3515 -7670 49 3517 3518 -7671 49 3520 3521 -7672 49 3523 3524 -7673 49 3526 3527 -7674 49 3529 3530 -7675 49 3532 3533 -7676 49 3535 3536 -7677 49 3538 3539 -7678 49 3541 3542 -7679 49 3544 3545 -7680 49 3547 3548 -7681 49 3550 3551 -7682 49 3553 3554 -7683 49 3556 3557 -7684 49 3559 3560 -7685 49 3562 3563 -7686 49 3565 3566 -7687 49 3568 3569 -7688 49 3571 3572 -7689 49 3574 3575 -7690 49 3577 3578 -7691 49 3580 3581 -7692 49 3583 3584 -7693 49 3586 3587 -7694 49 3589 3590 -7695 49 3592 3593 -7696 49 3595 3596 -7697 49 3598 3599 -7698 49 3601 3602 -7699 49 3604 3605 -7700 49 3607 3608 -7701 49 3610 3611 -7702 49 3613 3614 -7703 49 3616 3617 -7704 49 3619 3620 -7705 49 3622 3623 -7706 49 3625 3626 -7707 49 3628 3629 -7708 49 3631 3632 -7709 49 3634 3635 -7710 49 3637 3638 -7711 49 3640 3641 -7712 49 3643 3644 -7713 49 3646 3647 -7714 49 3649 3650 -7715 49 3652 3653 -7716 49 3655 3656 -7717 49 3658 3659 -7718 49 3661 3662 -7719 49 3664 3665 -7720 49 3667 3668 -7721 49 3670 3671 -7722 49 3673 3674 -7723 49 3676 3677 -7724 49 3679 3680 -7725 49 3682 3683 -7726 49 3685 3686 -7727 49 3688 3689 -7728 49 3691 3692 -7729 49 3694 3695 -7730 49 3697 3698 -7731 49 3700 3701 -7732 49 3703 3704 -7733 49 3706 3707 -7734 49 3709 3710 -7735 49 3712 3713 -7736 49 3715 3716 -7737 49 3718 3719 -7738 49 3721 3722 -7739 49 3724 3725 -7740 49 3727 3728 -7741 49 3730 3731 -7742 49 3733 3734 -7743 49 3736 3737 -7744 49 3739 3740 -7745 49 3742 3743 -7746 49 3745 3746 -7747 49 3748 3749 -7748 49 3751 3752 -7749 49 3754 3755 -7750 49 3757 3758 -7751 49 3760 3761 -7752 49 3763 3764 -7753 49 3766 3767 -7754 49 3769 3770 -7755 49 3772 3773 -7756 49 3775 3776 -7757 49 3778 3779 -7758 49 3781 3782 -7759 49 3784 3785 -7760 49 3787 3788 -7761 49 3790 3791 -7762 49 3793 3794 -7763 49 3796 3797 -7764 49 3799 3800 -7765 49 3802 3803 -7766 49 3805 3806 -7767 49 3808 3809 -7768 49 3811 3812 -7769 49 3814 3815 -7770 49 3817 3818 -7771 49 3820 3821 -7772 49 3823 3824 -7773 49 3826 3827 -7774 49 3829 3830 -7775 49 3832 3833 -7776 49 3835 3836 -7777 49 3838 3839 -7778 49 3841 3842 -7779 49 3844 3845 -7780 49 3847 3848 -7781 49 3850 3851 -7782 49 3853 3854 -7783 49 3856 3857 -7784 49 3859 3860 -7785 49 3862 3863 -7786 49 3865 3866 -7787 49 3868 3869 -7788 49 3871 3872 -7789 49 3874 3875 -7790 49 3877 3878 -7791 49 3880 3881 -7792 49 3883 3884 -7793 49 3886 3887 -7794 49 3889 3890 -7795 49 3892 3893 -7796 49 3895 3896 -7797 49 3898 3899 -7798 49 3901 3902 -7799 49 3904 3905 -7800 49 3907 3908 -7801 49 3910 3911 -7802 49 3913 3914 -7803 49 3916 3917 -7804 49 3919 3920 -7805 49 3922 3923 -7806 49 3925 3926 -7807 49 3928 3929 -7808 49 3931 3932 -7809 49 3934 3935 -7810 49 3937 3938 -7811 49 3940 3941 -7812 49 3943 3944 -7813 49 3946 3947 -7814 49 3949 3950 -7815 49 3952 3953 -7816 49 3955 3956 -7817 49 3958 3959 -7818 49 3961 3962 -7819 49 3964 3965 -7820 49 3967 3968 -7821 49 3970 3971 -7822 49 3973 3974 -7823 49 3976 3977 -7824 49 3979 3980 -7825 49 3982 3983 -7826 49 3985 3986 -7827 49 3988 3989 -7828 49 3991 3992 -7829 49 3994 3995 -7830 49 3997 3998 -7831 49 4000 4001 -7832 49 4003 4004 -7833 49 4006 4007 -7834 49 4009 4010 -7835 49 4012 4013 -7836 49 4015 4016 -7837 49 4018 4019 -7838 49 4021 4022 -7839 49 4024 4025 -7840 49 4027 4028 -7841 49 4030 4031 -7842 49 4033 4034 -7843 49 4036 4037 -7844 49 4039 4040 -7845 49 4042 4043 -7846 49 4045 4046 -7847 49 4048 4049 -7848 49 4051 4052 -7849 49 4054 4055 -7850 49 4057 4058 -7851 49 4060 4061 -7852 49 4063 4064 -7853 49 4066 4067 -7854 49 4069 4070 -7855 49 4072 4073 -7856 49 4075 4076 -7857 49 4078 4079 -7858 49 4081 4082 -7859 49 4084 4085 -7860 49 4087 4088 -7861 49 4090 4091 -7862 49 4093 4094 -7863 49 4096 4097 -7864 49 4099 4100 -7865 49 4102 4103 -7866 49 4105 4106 -7867 49 4108 4109 -7868 49 4111 4112 -7869 49 4114 4115 -7870 49 4117 4118 -7871 49 4120 4121 -7872 49 4123 4124 -7873 49 4126 4127 -7874 49 4129 4130 -7875 49 4132 4133 -7876 49 4135 4136 -7877 49 4138 4139 -7878 49 4141 4142 -7879 49 4144 4145 -7880 49 4147 4148 -7881 49 4150 4151 -7882 49 4153 4154 -7883 49 4156 4157 -7884 49 4159 4160 -7885 49 4162 4163 -7886 49 4165 4166 -7887 49 4168 4169 -7888 49 4171 4172 -7889 49 4174 4175 -7890 49 4177 4178 -7891 49 4180 4181 -7892 49 4183 4184 -7893 49 4186 4187 -7894 49 4189 4190 -7895 49 4192 4193 -7896 49 4195 4196 -7897 49 4198 4199 -7898 49 4201 4202 -7899 49 4204 4205 -7900 49 4207 4208 -7901 49 4210 4211 -7902 49 4213 4214 -7903 49 4216 4217 -7904 49 4219 4220 -7905 49 4222 4223 -7906 49 4225 4226 -7907 49 4228 4229 -7908 49 4231 4232 -7909 49 4234 4235 -7910 49 4237 4238 -7911 49 4240 4241 -7912 49 4243 4244 -7913 49 4246 4247 -7914 49 4249 4250 -7915 49 4252 4253 -7916 49 4255 4256 -7917 49 4258 4259 -7918 49 4261 4262 -7919 49 4264 4265 -7920 49 4267 4268 -7921 49 4270 4271 -7922 49 4273 4274 -7923 49 4276 4277 -7924 49 4279 4280 -7925 49 4282 4283 -7926 49 4285 4286 -7927 49 4288 4289 -7928 49 4291 4292 -7929 49 4294 4295 -7930 49 4297 4298 -7931 49 4300 4301 -7932 49 4303 4304 -7933 49 4306 4307 -7934 49 4309 4310 -7935 49 4312 4313 -7936 49 4315 4316 -7937 49 4318 4319 -7938 49 4321 4322 -7939 49 4324 4325 -7940 49 4327 4328 -7941 49 4330 4331 -7942 49 4333 4334 -7943 49 4336 4337 -7944 49 4339 4340 -7945 49 4342 4343 -7946 49 4345 4346 -7947 49 4348 4349 -7948 49 4351 4352 -7949 49 4354 4355 -7950 49 4357 4358 -7951 49 4360 4361 -7952 49 4363 4364 -7953 49 4366 4367 -7954 49 4369 4370 -7955 49 4372 4373 -7956 49 4375 4376 -7957 49 4378 4379 -7958 49 4381 4382 -7959 49 4384 4385 -7960 49 4387 4388 -7961 49 4390 4391 -7962 49 4393 4394 -7963 49 4396 4397 -7964 49 4399 4400 -7965 49 4402 4403 -7966 49 4405 4406 -7967 49 4408 4409 -7968 49 4411 4412 -7969 49 4414 4415 -7970 49 4417 4418 -7971 49 4420 4421 -7972 49 4423 4424 -7973 49 4426 4427 -7974 49 4429 4430 -7975 49 4432 4433 -7976 49 4435 4436 -7977 49 4438 4439 -7978 49 4441 4442 -7979 49 4444 4445 -7980 49 4447 4448 -7981 49 4450 4451 -7982 49 4453 4454 -7983 49 4456 4457 -7984 49 4459 4460 -7985 49 4462 4463 -7986 49 4465 4466 -7987 49 4468 4469 -7988 49 4471 4472 -7989 49 4474 4475 -7990 49 4477 4478 -7991 49 4480 4481 -7992 49 4483 4484 -7993 49 4486 4487 -7994 49 4489 4490 -7995 49 4492 4493 -7996 49 4495 4496 -7997 49 4498 4499 -7998 49 4501 4502 -7999 49 4504 4505 -8000 49 4507 4508 -8001 49 4510 4511 -8002 49 4513 4514 -8003 49 4516 4517 -8004 49 4519 4520 -8005 49 4522 4523 -8006 49 4525 4526 -8007 49 4528 4529 -8008 49 4531 4532 -8009 49 4534 4535 -8010 49 4537 4538 -8011 49 4540 4541 -8012 49 4543 4544 -8013 49 4546 4547 -8014 49 4549 4550 -8015 49 4552 4553 -8016 49 4555 4556 -8017 49 4558 4559 -8018 49 4561 4562 -8019 49 4564 4565 -8020 49 4567 4568 -8021 49 4570 4571 -8022 49 4573 4574 -8023 49 4576 4577 -8024 49 4579 4580 -8025 49 4582 4583 -8026 49 4585 4586 -8027 49 4588 4589 -8028 49 4591 4592 -8029 49 4594 4595 -8030 49 4597 4598 -8031 49 4600 4601 -8032 49 4603 4604 -8033 49 4606 4607 -8034 49 4609 4610 -8035 49 4612 4613 -8036 49 4615 4616 -8037 49 4618 4619 -8038 49 4621 4622 -8039 49 4624 4625 -8040 49 4627 4628 -8041 49 4630 4631 -8042 49 4633 4634 -8043 49 4636 4637 -8044 49 4639 4640 -8045 49 4642 4643 -8046 49 4645 4646 -8047 49 4648 4649 -8048 49 4651 4652 -8049 49 4654 4655 -8050 49 4657 4658 -8051 49 4660 4661 -8052 49 4663 4664 -8053 49 4666 4667 -8054 49 4669 4670 -8055 49 4672 4673 -8056 49 4675 4676 -8057 49 4678 4679 -8058 49 4681 4682 -8059 49 4684 4685 -8060 49 4687 4688 -8061 49 4690 4691 -8062 49 4693 4694 -8063 49 4696 4697 -8064 49 4699 4700 -8065 49 4702 4703 -8066 49 4705 4706 -8067 49 4708 4709 -8068 49 4711 4712 -8069 49 4714 4715 -8070 49 4717 4718 -8071 49 4720 4721 -8072 49 4723 4724 -8073 49 4726 4727 -8074 49 4729 4730 -8075 49 4732 4733 -8076 49 4735 4736 -8077 49 4738 4739 -8078 49 4741 4742 -8079 49 4744 4745 -8080 49 4747 4748 -8081 49 4750 4751 -8082 49 4753 4754 -8083 49 4756 4757 -8084 49 4759 4760 -8085 49 4762 4763 -8086 49 4765 4766 -8087 49 4768 4769 -8088 49 4771 4772 -8089 49 4774 4775 -8090 49 4777 4778 -8091 49 4780 4781 -8092 49 4783 4784 -8093 49 4786 4787 -8094 49 4789 4790 -8095 49 4792 4793 -8096 49 4795 4796 -8097 49 4798 4799 -8098 49 4801 4802 -8099 49 4804 4805 -8100 49 4807 4808 -8101 49 4810 4811 -8102 49 4813 4814 -8103 49 4816 4817 -8104 49 4819 4820 -8105 49 4822 4823 -8106 49 4825 4826 -8107 49 4828 4829 -8108 49 4831 4832 -8109 49 4834 4835 -8110 49 4837 4838 -8111 49 4840 4841 -8112 49 4843 4844 -8113 49 4846 4847 -8114 49 4849 4850 -8115 49 4852 4853 -8116 49 4855 4856 -8117 49 4858 4859 -8118 49 4861 4862 -8119 49 4864 4865 -8120 49 4867 4868 -8121 49 4870 4871 -8122 49 4873 4874 -8123 49 4876 4877 -8124 49 4879 4880 -8125 49 4882 4883 -8126 49 4885 4886 -8127 49 4888 4889 -8128 49 4891 4892 -8129 49 4894 4895 -8130 49 4897 4898 -8131 49 4900 4901 -8132 49 4903 4904 -8133 49 4906 4907 -8134 49 4909 4910 -8135 49 4912 4913 -8136 49 4915 4916 -8137 49 4918 4919 -8138 49 4921 4922 -8139 49 4924 4925 -8140 49 4927 4928 -8141 49 4930 4931 -8142 49 4933 4934 -8143 49 4936 4937 -8144 49 4939 4940 -8145 49 4942 4943 -8146 49 4945 4946 -8147 49 4948 4949 -8148 49 4951 4952 -8149 49 4954 4955 -8150 49 4957 4958 -8151 49 4960 4961 -8152 49 4963 4964 -8153 49 4966 4967 -8154 49 4969 4970 -8155 49 4972 4973 -8156 49 4975 4976 -8157 49 4978 4979 -8158 49 4981 4982 -8159 49 4984 4985 -8160 49 4987 4988 -8161 49 4990 4991 -8162 49 4993 4994 -8163 49 4996 4997 -8164 49 4999 5000 -8165 49 5002 5003 -8166 49 5005 5006 -8167 49 5008 5009 -8168 49 5011 5012 -8169 49 5014 5015 -8170 49 5017 5018 -8171 49 5020 5021 -8172 49 5023 5024 -8173 49 5026 5027 -8174 49 5029 5030 -8175 49 5032 5033 -8176 49 5035 5036 -8177 49 5038 5039 -8178 49 5041 5042 -8179 49 5044 5045 -8180 49 5047 5048 -8181 49 5050 5051 -8182 49 5053 5054 -8183 49 5056 5057 -8184 49 5059 5060 -8185 49 5062 5063 -8186 49 5065 5066 -8187 49 5068 5069 -8188 49 5071 5072 -8189 49 5074 5075 -8190 49 5077 5078 -8191 49 5080 5081 -8192 49 5083 5084 -8193 49 5086 5087 -8194 49 5089 5090 -8195 49 5092 5093 -8196 49 5095 5096 -8197 49 5098 5099 -8198 49 5101 5102 -8199 49 5104 5105 -8200 49 5107 5108 -8201 49 5110 5111 -8202 49 5113 5114 -8203 49 5116 5117 -8204 49 5119 5120 -8205 49 5122 5123 -8206 49 5125 5126 -8207 49 5128 5129 -8208 49 5131 5132 -8209 49 5134 5135 -8210 49 5137 5138 -8211 49 5140 5141 -8212 49 5143 5144 -8213 49 5146 5147 -8214 49 5149 5150 -8215 49 5152 5153 -8216 49 5155 5156 -8217 49 5158 5159 -8218 49 5161 5162 -8219 49 5164 5165 -8220 49 5167 5168 -8221 49 5170 5171 -8222 49 5173 5174 -8223 49 5176 5177 -8224 49 5179 5180 -8225 49 5182 5183 -8226 49 5185 5186 -8227 49 5188 5189 -8228 49 5191 5192 -8229 49 5194 5195 -8230 49 5197 5198 -8231 49 5200 5201 -8232 49 5203 5204 -8233 49 5206 5207 -8234 49 5209 5210 -8235 49 5212 5213 -8236 49 5215 5216 -8237 49 5218 5219 -8238 49 5221 5222 -8239 49 5224 5225 -8240 49 5227 5228 -8241 49 5230 5231 -8242 49 5233 5234 -8243 49 5236 5237 -8244 49 5239 5240 -8245 49 5242 5243 -8246 49 5245 5246 -8247 49 5248 5249 -8248 49 5251 5252 -8249 49 5254 5255 -8250 49 5257 5258 -8251 49 5260 5261 -8252 49 5263 5264 -8253 49 5266 5267 -8254 49 5269 5270 -8255 49 5272 5273 -8256 49 5275 5276 -8257 49 5278 5279 -8258 49 5281 5282 -8259 49 5284 5285 -8260 49 5287 5288 -8261 49 5290 5291 -8262 49 5293 5294 -8263 49 5296 5297 -8264 49 5299 5300 -8265 49 5302 5303 -8266 49 5305 5306 -8267 49 5308 5309 -8268 49 5311 5312 -8269 49 5314 5315 -8270 49 5317 5318 -8271 49 5320 5321 -8272 49 5323 5324 -8273 49 5326 5327 -8274 49 5329 5330 -8275 49 5332 5333 -8276 49 5335 5336 -8277 49 5338 5339 -8278 49 5341 5342 -8279 49 5344 5345 -8280 49 5347 5348 -8281 49 5350 5351 -8282 49 5353 5354 -8283 49 5356 5357 -8284 49 5359 5360 -8285 49 5362 5363 -8286 49 5365 5366 -8287 49 5368 5369 -8288 49 5371 5372 -8289 49 5374 5375 -8290 49 5377 5378 -8291 49 5380 5381 -8292 49 5383 5384 -8293 49 5386 5387 -8294 49 5389 5390 -8295 49 5392 5393 -8296 49 5395 5396 -8297 49 5398 5399 -8298 49 5401 5402 -8299 49 5404 5405 -8300 49 5407 5408 -8301 49 5410 5411 -8302 49 5413 5414 -8303 49 5416 5417 -8304 49 5419 5420 -8305 49 5422 5423 -8306 49 5425 5426 -8307 49 5428 5429 -8308 49 5431 5432 -8309 49 5434 5435 -8310 49 5437 5438 -8311 49 5440 5441 -8312 49 5443 5444 -8313 49 5446 5447 -8314 49 5449 5450 -8315 49 5452 5453 -8316 49 5455 5456 -8317 49 5458 5459 -8318 49 5461 5462 -8319 49 5464 5465 -8320 49 5467 5468 -8321 49 5470 5471 -8322 49 5473 5474 -8323 49 5476 5477 -8324 49 5479 5480 -8325 49 5482 5483 -8326 49 5485 5486 -8327 49 5488 5489 -8328 49 5491 5492 -8329 49 5494 5495 -8330 49 5497 5498 -8331 49 5500 5501 -8332 49 5503 5504 -8333 49 5506 5507 -8334 49 5509 5510 -8335 49 5512 5513 -8336 49 5515 5516 -8337 49 5518 5519 -8338 49 5521 5522 -8339 49 5524 5525 -8340 49 5527 5528 -8341 49 5530 5531 -8342 49 5533 5534 -8343 49 5536 5537 -8344 49 5539 5540 -8345 49 5542 5543 -8346 49 5545 5546 -8347 49 5548 5549 -8348 49 5551 5552 -8349 49 5554 5555 -8350 49 5557 5558 -8351 49 5560 5561 -8352 49 5563 5564 -8353 49 5566 5567 -8354 49 5569 5570 -8355 49 5572 5573 -8356 49 5575 5576 -8357 49 5578 5579 -8358 49 5581 5582 -8359 49 5584 5585 -8360 49 5587 5588 -8361 49 5590 5591 -8362 49 5593 5594 -8363 49 5596 5597 -8364 49 5599 5600 -8365 49 5602 5603 -8366 49 5605 5606 -8367 49 5608 5609 -8368 49 5611 5612 -8369 49 5614 5615 -8370 49 5617 5618 -8371 49 5620 5621 -8372 49 5623 5624 -8373 49 5626 5627 -8374 49 5629 5630 -8375 49 5632 5633 -8376 49 5635 5636 -8377 49 5638 5639 -8378 49 5641 5642 -8379 49 5644 5645 -8380 49 5647 5648 -8381 49 5650 5651 -8382 49 5653 5654 -8383 49 5656 5657 -8384 49 5659 5660 -8385 49 5662 5663 -8386 49 5665 5666 -8387 49 5668 5669 -8388 49 5671 5672 -8389 49 5674 5675 -8390 49 5677 5678 -8391 49 5680 5681 -8392 49 5683 5684 -8393 49 5686 5687 -8394 49 5689 5690 -8395 49 5692 5693 -8396 49 5695 5696 -8397 49 5698 5699 -8398 49 5701 5702 -8399 49 5704 5705 -8400 49 5707 5708 -8401 49 5710 5711 -8402 49 5713 5714 -8403 49 5716 5717 -8404 49 5719 5720 -8405 49 5722 5723 -8406 49 5725 5726 -8407 49 5728 5729 -8408 49 5731 5732 -8409 49 5734 5735 -8410 49 5737 5738 -8411 49 5740 5741 -8412 49 5743 5744 -8413 49 5746 5747 -8414 49 5749 5750 -8415 49 5752 5753 -8416 49 5755 5756 -8417 49 5758 5759 -8418 49 5761 5762 -8419 49 5764 5765 -8420 49 5767 5768 -8421 49 5770 5771 -8422 49 5773 5774 -8423 49 5776 5777 -8424 49 5779 5780 -8425 49 5782 5783 -8426 49 5785 5786 -8427 49 5788 5789 -8428 49 5791 5792 -8429 49 5794 5795 -8430 49 5797 5798 -8431 49 5800 5801 -8432 49 5803 5804 -8433 49 5806 5807 -8434 49 5809 5810 -8435 49 5812 5813 -8436 49 5815 5816 -8437 49 5818 5819 -8438 49 5821 5822 -8439 49 5824 5825 -8440 49 5827 5828 -8441 49 5830 5831 -8442 49 5833 5834 -8443 49 5836 5837 -8444 49 5839 5840 -8445 49 5842 5843 -8446 49 5845 5846 -8447 49 5848 5849 -8448 49 5851 5852 -8449 49 5854 5855 -8450 49 5857 5858 -8451 49 5860 5861 -8452 49 5863 5864 -8453 49 5866 5867 -8454 49 5869 5870 -8455 49 5872 5873 -8456 49 5875 5876 -8457 49 5878 5879 -8458 49 5881 5882 -8459 49 5884 5885 -8460 49 5887 5888 -8461 49 5890 5891 -8462 49 5893 5894 -8463 49 5896 5897 -8464 49 5899 5900 -8465 49 5902 5903 -8466 49 5905 5906 -8467 49 5908 5909 -8468 49 5911 5912 -8469 49 5914 5915 -8470 49 5917 5918 -8471 49 5920 5921 -8472 49 5923 5924 -8473 49 5926 5927 -8474 49 5929 5930 -8475 49 5932 5933 -8476 49 5935 5936 -8477 49 5938 5939 -8478 49 5941 5942 -8479 49 5944 5945 -8480 49 5947 5948 -8481 49 5950 5951 -8482 49 5953 5954 -8483 49 5956 5957 -8484 49 5959 5960 -8485 49 5962 5963 -8486 49 5965 5966 -8487 49 5968 5969 -8488 49 5971 5972 -8489 49 5974 5975 -8490 49 5977 5978 -8491 49 5980 5981 -8492 49 5983 5984 -8493 49 5986 5987 -8494 49 5989 5990 -8495 49 5992 5993 -8496 49 5995 5996 -8497 49 5998 5999 -8498 49 6001 6002 -8499 49 6004 6005 -8500 49 6007 6008 -8501 49 6010 6011 -8502 49 6013 6014 -8503 49 6016 6017 -8504 49 6019 6020 -8505 49 6022 6023 -8506 49 6025 6026 -8507 49 6028 6029 -8508 49 6031 6032 -8509 49 6034 6035 -8510 49 6037 6038 -8511 49 6040 6041 -8512 49 6043 6044 -8513 49 6046 6047 -8514 49 6049 6050 -8515 49 6052 6053 -8516 49 6055 6056 -8517 49 6058 6059 -8518 49 6061 6062 -8519 49 6064 6065 -8520 49 6067 6068 -8521 49 6070 6071 -8522 49 6073 6074 -8523 49 6076 6077 -8524 49 6079 6080 -8525 49 6082 6083 -8526 49 6085 6086 -8527 49 6088 6089 -8528 49 6091 6092 -8529 49 6094 6095 -8530 49 6097 6098 -8531 49 6100 6101 -8532 49 6103 6104 -8533 49 6106 6107 -8534 49 6109 6110 -8535 49 6112 6113 -8536 49 6115 6116 -8537 49 6118 6119 -8538 49 6121 6122 -8539 49 6124 6125 -8540 49 6127 6128 -8541 49 6130 6131 -8542 49 6133 6134 -8543 49 6136 6137 -8544 49 6139 6140 -8545 49 6142 6143 -8546 49 6145 6146 -8547 49 6148 6149 -8548 49 6151 6152 -8549 49 6154 6155 -8550 49 6157 6158 -8551 49 6160 6161 -8552 49 6163 6164 -8553 49 6166 6167 -8554 49 6169 6170 -8555 49 6172 6173 -8556 49 6175 6176 -8557 49 6178 6179 -8558 49 6181 6182 -8559 49 6184 6185 -8560 49 6187 6188 -8561 49 6190 6191 -8562 49 6193 6194 -8563 49 6196 6197 -8564 49 6199 6200 -8565 49 6202 6203 -8566 49 6205 6206 -8567 49 6208 6209 -8568 49 6211 6212 -8569 49 6214 6215 -8570 49 6217 6218 -8571 49 6220 6221 -8572 49 6223 6224 -8573 49 6226 6227 -8574 49 6229 6230 -8575 49 6232 6233 -8576 49 6235 6236 -8577 49 6238 6239 -8578 49 6241 6242 -8579 49 6244 6245 -8580 49 6247 6248 -8581 49 6250 6251 -8582 49 6253 6254 -8583 49 6256 6257 -8584 49 6259 6260 -8585 49 6262 6263 -8586 49 6265 6266 -8587 49 6268 6269 -8588 49 6271 6272 -8589 49 6274 6275 -8590 49 6277 6278 -8591 49 6280 6281 -8592 49 6283 6284 -8593 49 6286 6287 -8594 49 6289 6290 -8595 49 6292 6293 -8596 49 6295 6296 -8597 49 6298 6299 -8598 49 6301 6302 -8599 49 6304 6305 -8600 49 6307 6308 -8601 49 6310 6311 -8602 49 6313 6314 -8603 49 6316 6317 -8604 49 6319 6320 -8605 49 6322 6323 -8606 49 6325 6326 -8607 49 6328 6329 -8608 49 6331 6332 -8609 49 6334 6335 -8610 49 6337 6338 -8611 49 6340 6341 -8612 49 6343 6344 -8613 49 6346 6347 -8614 49 6349 6350 -8615 49 6352 6353 -8616 49 6355 6356 -8617 49 6358 6359 -8618 49 6361 6362 -8619 49 6364 6365 -8620 49 6367 6368 -8621 49 6370 6371 -8622 49 6373 6374 -8623 49 6376 6377 -8624 49 6379 6380 -8625 49 6382 6383 -8626 49 6385 6386 -8627 49 6388 6389 -8628 49 6391 6392 -8629 49 6394 6395 -8630 49 6397 6398 -8631 49 6400 6401 -8632 49 6403 6404 -8633 49 6406 6407 -8634 49 6409 6410 -8635 49 6412 6413 -8636 49 6415 6416 -8637 49 6418 6419 -8638 49 6421 6422 -8639 49 6424 6425 -8640 49 6427 6428 -8641 49 6430 6431 -8642 49 6433 6434 -8643 49 6436 6437 -8644 49 6439 6440 -8645 49 6442 6443 -8646 49 6445 6446 -8647 49 6448 6449 -8648 49 6451 6452 -8649 49 6454 6455 -8650 49 6457 6458 -8651 49 6460 6461 -8652 49 6463 6464 -8653 49 6466 6467 -8654 49 6469 6470 -8655 49 6472 6473 -8656 49 6475 6476 -8657 49 6478 6479 -8658 49 6481 6482 -8659 49 6484 6485 -8660 49 6487 6488 -8661 49 6490 6491 -8662 49 6493 6494 -8663 49 6496 6497 -8664 49 6499 6500 -8665 49 6502 6503 -8666 49 6505 6506 -8667 49 6508 6509 -8668 49 6511 6512 -8669 49 6514 6515 -8670 49 6517 6518 -8671 49 6520 6521 -8672 49 6523 6524 -8673 49 6526 6527 -8674 49 6529 6530 -8675 49 6532 6533 -8676 49 6535 6536 -8677 49 6538 6539 -8678 49 6541 6542 -8679 49 6544 6545 -8680 49 6547 6548 -8681 49 6550 6551 -8682 49 6553 6554 -8683 49 6556 6557 -8684 49 6559 6560 -8685 49 6562 6563 -8686 49 6565 6566 -8687 49 6568 6569 -8688 49 6571 6572 -8689 49 6574 6575 -8690 49 6577 6578 -8691 49 6580 6581 -8692 49 6583 6584 -8693 49 6586 6587 -8694 49 6589 6590 -8695 49 6592 6593 -8696 49 6595 6596 -8697 49 6598 6599 -8698 49 6601 6602 -8699 49 6604 6605 -8700 49 6607 6608 -8701 49 6610 6611 -8702 49 6613 6614 -8703 49 6616 6617 -8704 49 6619 6620 -8705 49 6622 6623 -8706 49 6625 6626 -8707 49 6628 6629 -8708 49 6631 6632 -8709 49 6634 6635 -8710 49 6637 6638 -8711 49 6640 6641 -8712 49 6643 6644 -8713 49 6646 6647 -8714 49 6649 6650 -8715 49 6652 6653 -8716 49 6655 6656 -8717 49 6658 6659 -8718 49 6661 6662 -8719 49 6664 6665 -8720 49 6667 6668 -8721 49 6670 6671 -8722 49 6673 6674 -8723 49 6676 6677 -8724 49 6679 6680 -8725 49 6682 6683 -8726 49 6685 6686 -8727 49 6688 6689 -8728 49 6691 6692 -8729 49 6694 6695 -8730 49 6697 6698 -8731 49 6700 6701 -8732 49 6703 6704 -8733 49 6706 6707 -8734 49 6709 6710 -8735 49 6712 6713 -8736 49 6715 6716 -8737 49 6718 6719 -8738 49 6721 6722 -8739 49 6724 6725 -8740 49 6727 6728 -8741 49 6730 6731 -8742 49 6733 6734 -8743 49 6736 6737 -8744 49 6739 6740 -8745 49 6742 6743 -8746 49 6745 6746 -8747 49 6748 6749 -8748 49 6751 6752 -8749 49 6754 6755 -8750 49 6757 6758 -8751 49 6760 6761 -8752 49 6763 6764 -8753 49 6766 6767 -8754 49 6769 6770 -8755 49 6772 6773 -8756 49 6775 6776 -8757 49 6778 6779 -8758 49 6781 6782 -8759 49 6784 6785 -8760 49 6787 6788 -8761 49 6790 6791 -8762 49 6793 6794 -8763 49 6796 6797 -8764 49 6799 6800 -8765 49 6802 6803 -8766 49 6805 6806 -8767 49 6808 6809 -8768 49 6811 6812 -8769 49 6814 6815 -8770 49 6817 6818 -8771 49 6820 6821 -8772 49 6823 6824 -8773 49 6826 6827 -8774 49 6829 6830 -8775 49 6832 6833 -8776 49 6835 6836 -8777 49 6838 6839 -8778 49 6841 6842 -8779 49 6844 6845 -8780 49 6847 6848 -8781 49 6850 6851 -8782 49 6853 6854 -8783 49 6856 6857 -8784 49 6859 6860 -8785 49 6862 6863 -8786 49 6865 6866 -8787 49 6868 6869 -8788 49 6871 6872 -8789 49 6874 6875 -8790 49 6877 6878 -8791 49 6880 6881 -8792 49 6883 6884 -8793 49 6886 6887 -8794 49 6889 6890 -8795 49 6892 6893 -8796 49 6895 6896 -8797 49 6898 6899 -8798 49 6901 6902 -8799 49 6904 6905 -8800 49 6907 6908 -8801 49 6910 6911 -8802 49 6913 6914 -8803 49 6916 6917 -8804 49 6919 6920 -8805 49 6922 6923 -8806 49 6925 6926 -8807 49 6928 6929 -8808 49 6931 6932 -8809 49 6934 6935 -8810 49 6937 6938 -8811 49 6940 6941 -8812 49 6943 6944 -8813 49 6946 6947 -8814 49 6949 6950 -8815 49 6952 6953 -8816 49 6955 6956 -8817 49 6958 6959 -8818 49 6961 6962 -8819 49 6964 6965 -8820 49 6967 6968 -8821 49 6970 6971 -8822 49 6973 6974 -8823 49 6976 6977 -8824 49 6979 6980 -8825 49 6982 6983 -8826 49 6985 6986 -8827 49 6988 6989 -8828 49 6991 6992 -8829 49 6994 6995 -8830 49 6997 6998 -8831 49 7000 7001 -8832 49 7003 7004 -8833 49 7006 7007 -8834 49 7009 7010 -8835 49 7012 7013 -8836 49 7015 7016 -8837 49 7018 7019 -8838 49 7021 7022 -8839 49 7024 7025 -8840 49 7027 7028 -8841 49 7030 7031 -8842 49 7033 7034 -8843 49 7036 7037 -8844 49 7039 7040 -8845 49 7042 7043 -8846 49 7045 7046 -8847 49 7048 7049 -8848 49 7051 7052 -8849 49 7054 7055 -8850 49 7057 7058 -8851 49 7060 7061 -8852 49 7063 7064 -8853 49 7066 7067 -8854 49 7069 7070 -8855 49 7072 7073 -8856 49 7075 7076 -8857 49 7078 7079 -8858 49 7081 7082 -8859 49 7084 7085 -8860 49 7087 7088 -8861 49 7090 7091 -8862 49 7093 7094 -8863 49 7096 7097 -8864 49 7099 7100 -8865 49 7102 7103 -8866 49 7105 7106 -8867 49 7108 7109 -8868 49 7111 7112 -8869 49 7114 7115 -8870 49 7117 7118 -8871 49 7120 7121 -8872 49 7123 7124 -8873 49 7126 7127 -8874 49 7129 7130 -8875 49 7132 7133 -8876 49 7135 7136 -8877 49 7138 7139 -8878 49 7141 7142 -8879 49 7144 7145 -8880 49 7147 7148 -8881 49 7150 7151 -8882 49 7153 7154 -8883 49 7156 7157 -8884 49 7159 7160 -8885 49 7162 7163 -8886 49 7165 7166 -8887 49 7168 7169 -8888 49 7171 7172 -8889 49 7174 7175 -8890 49 7177 7178 -8891 49 7180 7181 -8892 49 7183 7184 -8893 49 7186 7187 -8894 49 7189 7190 -8895 49 7192 7193 -8896 49 7195 7196 -8897 49 7198 7199 -8898 49 7201 7202 -8899 49 7204 7205 -8900 49 7207 7208 -8901 49 7210 7211 -8902 49 7213 7214 -8903 49 7216 7217 -8904 49 7219 7220 -8905 49 7222 7223 -8906 49 7225 7226 -8907 49 7228 7229 -8908 49 7231 7232 -8909 49 7234 7235 -8910 49 7237 7238 -8911 49 7240 7241 -8912 49 7243 7244 -8913 49 7246 7247 -8914 49 7249 7250 -8915 49 7252 7253 -8916 49 7255 7256 -8917 49 7258 7259 -8918 49 7261 7262 -8919 49 7264 7265 -8920 49 7267 7268 -8921 49 7270 7271 -8922 49 7273 7274 -8923 49 7276 7277 -8924 49 7279 7280 -8925 49 7282 7283 -8926 49 7285 7286 -8927 49 7288 7289 -8928 49 7291 7292 -8929 49 7294 7295 -8930 49 7297 7298 -8931 49 7300 7301 -8932 49 7303 7304 -8933 49 7306 7307 -8934 49 7309 7310 -8935 49 7312 7313 -8936 49 7315 7316 -8937 49 7318 7319 -8938 49 7321 7322 -8939 49 7324 7325 -8940 49 7327 7328 -8941 49 7330 7331 -8942 49 7333 7334 -8943 49 7336 7337 -8944 49 7339 7340 -8945 49 7342 7343 -8946 49 7345 7346 -8947 49 7348 7349 -8948 49 7351 7352 -8949 49 7354 7355 -8950 49 7357 7358 -8951 49 7360 7361 -8952 49 7363 7364 -8953 49 7366 7367 -8954 49 7369 7370 -8955 49 7372 7373 -8956 49 7375 7376 -8957 49 7378 7379 -8958 49 7381 7382 -8959 49 7384 7385 -8960 49 7387 7388 -8961 49 7390 7391 -8962 49 7393 7394 -8963 49 7396 7397 -8964 49 7399 7400 -8965 49 7402 7403 -8966 49 7405 7406 -8967 49 7408 7409 -8968 49 7411 7412 -8969 49 7414 7415 -8970 49 7417 7418 -8971 49 7420 7421 -8972 49 7423 7424 -8973 49 7426 7427 -8974 49 7429 7430 -8975 49 7432 7433 -8976 49 7435 7436 -8977 49 7438 7439 -8978 49 7441 7442 -8979 49 7444 7445 -8980 49 7447 7448 -8981 49 7450 7451 -8982 49 7453 7454 -8983 49 7456 7457 -8984 49 7459 7460 -8985 49 7462 7463 -8986 49 7465 7466 -8987 49 7468 7469 -8988 49 7471 7472 -8989 49 7474 7475 -8990 49 7477 7478 -8991 49 7480 7481 -8992 49 7483 7484 -8993 49 7486 7487 -8994 49 7489 7490 -8995 49 7492 7493 -8996 49 7495 7496 -8997 49 7498 7499 -8998 49 7501 7502 -8999 49 7504 7505 -9000 49 7507 7508 -9001 49 7510 7511 -9002 49 7513 7514 -9003 49 7516 7517 -9004 49 7519 7520 -9005 49 7522 7523 -9006 49 7525 7526 -9007 49 7528 7529 -9008 49 7531 7532 -9009 49 7534 7535 -9010 49 7537 7538 -9011 49 7540 7541 -9012 49 7543 7544 -9013 49 7546 7547 -9014 49 7549 7550 -9015 49 7552 7553 -9016 49 7555 7556 -9017 49 7558 7559 -9018 49 7561 7562 -9019 49 7564 7565 -9020 49 7567 7568 -9021 49 7570 7571 -9022 49 7573 7574 -9023 49 7576 7577 -9024 49 7579 7580 -9025 49 7582 7583 -9026 49 7585 7586 -9027 49 7588 7589 -9028 49 7591 7592 -9029 49 7594 7595 -9030 49 7597 7598 -9031 49 7600 7601 -9032 49 7603 7604 -9033 49 7606 7607 -9034 49 7609 7610 -9035 49 7612 7613 -9036 49 7615 7616 -9037 49 7618 7619 -9038 49 7621 7622 -9039 49 7624 7625 -9040 49 7627 7628 -9041 49 7630 7631 -9042 49 7633 7634 -9043 49 7636 7637 -9044 49 7639 7640 -9045 49 7642 7643 -9046 49 7645 7646 -9047 49 7648 7649 -9048 49 7651 7652 -9049 49 7654 7655 -9050 49 7657 7658 -9051 49 7660 7661 -9052 49 7663 7664 -9053 49 7666 7667 -9054 49 7669 7670 -9055 49 7672 7673 -9056 49 7675 7676 -9057 49 7678 7679 -9058 49 7681 7682 -9059 49 7684 7685 -9060 49 7687 7688 -9061 49 7690 7691 -9062 49 7693 7694 -9063 49 7696 7697 -9064 49 7699 7700 -9065 49 7702 7703 -9066 49 7705 7706 -9067 49 7708 7709 -9068 49 7711 7712 -9069 49 7714 7715 -9070 49 7717 7718 -9071 49 7720 7721 -9072 49 7723 7724 -9073 49 7726 7727 -9074 49 7729 7730 -9075 49 7732 7733 -9076 49 7735 7736 -9077 49 7738 7739 -9078 49 7741 7742 -9079 49 7744 7745 -9080 49 7747 7748 -9081 49 7750 7751 -9082 49 7753 7754 -9083 49 7756 7757 -9084 49 7759 7760 -9085 49 7762 7763 -9086 49 7765 7766 -9087 49 7768 7769 -9088 49 7771 7772 -9089 49 7774 7775 -9090 49 7777 7778 -9091 49 7780 7781 -9092 49 7783 7784 -9093 49 7786 7787 -9094 49 7789 7790 -9095 49 7792 7793 -9096 49 7795 7796 -9097 49 7798 7799 -9098 49 7801 7802 -9099 49 7804 7805 -9100 49 7807 7808 -9101 49 7810 7811 -9102 49 7813 7814 -9103 49 7816 7817 -9104 49 7819 7820 -9105 49 7822 7823 -9106 49 7825 7826 -9107 49 7828 7829 -9108 49 7831 7832 -9109 49 7834 7835 -9110 49 7837 7838 -9111 49 7840 7841 -9112 49 7843 7844 -9113 49 7846 7847 -9114 49 7849 7850 -9115 49 7852 7853 -9116 49 7855 7856 -9117 49 7858 7859 -9118 49 7861 7862 -9119 49 7864 7865 -9120 49 7867 7868 -9121 49 7870 7871 -9122 49 7873 7874 -9123 49 7876 7877 -9124 49 7879 7880 -9125 49 7882 7883 -9126 49 7885 7886 -9127 49 7888 7889 -9128 49 7891 7892 -9129 49 7894 7895 -9130 49 7897 7898 -9131 49 7900 7901 -9132 49 7903 7904 -9133 49 7906 7907 -9134 49 7909 7910 -9135 49 7912 7913 -9136 49 7915 7916 -9137 49 7918 7919 -9138 49 7921 7922 -9139 49 7924 7925 -9140 49 7927 7928 -9141 49 7930 7931 -9142 49 7933 7934 -9143 49 7936 7937 -9144 49 7939 7940 -9145 49 7942 7943 -9146 49 7945 7946 -9147 49 7948 7949 -9148 49 7951 7952 -9149 49 7954 7955 -9150 49 7957 7958 -9151 49 7960 7961 -9152 49 7963 7964 -9153 49 7966 7967 -9154 49 7969 7970 -9155 49 7972 7973 -9156 49 7975 7976 -9157 49 7978 7979 -9158 49 7981 7982 -9159 49 7984 7985 -9160 49 7987 7988 -9161 49 7990 7991 -9162 49 7993 7994 -9163 49 7996 7997 -9164 49 7999 8000 -9165 49 8002 8003 -9166 49 8005 8006 -9167 49 8008 8009 -9168 49 8011 8012 -9169 49 8014 8015 -9170 49 8017 8018 -9171 49 8020 8021 -9172 49 8023 8024 -9173 49 8026 8027 -9174 49 8029 8030 -9175 49 8032 8033 -9176 49 8035 8036 -9177 49 8038 8039 -9178 49 8041 8042 -9179 49 8044 8045 -9180 49 8047 8048 -9181 49 8050 8051 -9182 49 8053 8054 -9183 49 8056 8057 -9184 49 8059 8060 -9185 49 8062 8063 -9186 49 8065 8066 -9187 49 8068 8069 -9188 49 8071 8072 -9189 49 8074 8075 -9190 49 8077 8078 -9191 49 8080 8081 -9192 49 8083 8084 -9193 49 8086 8087 -9194 49 8089 8090 -9195 49 8092 8093 -9196 49 8095 8096 -9197 49 8098 8099 -9198 49 8101 8102 -9199 49 8104 8105 -9200 49 8107 8108 -9201 49 8110 8111 -9202 49 8113 8114 -9203 49 8116 8117 -9204 49 8119 8120 -9205 49 8122 8123 -9206 49 8125 8126 -9207 49 8128 8129 -9208 49 8131 8132 -9209 49 8134 8135 -9210 49 8137 8138 -9211 49 8140 8141 -9212 49 8143 8144 -9213 49 8146 8147 -9214 49 8149 8150 -9215 49 8152 8153 -9216 49 8155 8156 -9217 49 8158 8159 -9218 49 8161 8162 -9219 49 8164 8165 -9220 49 8167 8168 -9221 49 8170 8171 -9222 49 8173 8174 -9223 49 8176 8177 -9224 49 8179 8180 -9225 49 8182 8183 -9226 49 8185 8186 -9227 49 8188 8189 -9228 49 8191 8192 -9229 49 8194 8195 -9230 49 8197 8198 -9231 49 8200 8201 -9232 49 8203 8204 -9233 49 8206 8207 -9234 49 8209 8210 -9235 49 8212 8213 -9236 49 8215 8216 -9237 49 8218 8219 -9238 49 8221 8222 -9239 49 8224 8225 -9240 49 8227 8228 -9241 49 8230 8231 -9242 49 8233 8234 -9243 49 8236 8237 -9244 49 8239 8240 -9245 49 8242 8243 -9246 49 8245 8246 -9247 49 8248 8249 -9248 49 8251 8252 -9249 49 8254 8255 -9250 49 8257 8258 -9251 49 8260 8261 -9252 49 8263 8264 -9253 49 8266 8267 -9254 49 8269 8270 -9255 49 8272 8273 -9256 49 8275 8276 -9257 49 8278 8279 -9258 49 8281 8282 -9259 49 8284 8285 -9260 49 8287 8288 -9261 49 8290 8291 -9262 49 8293 8294 -9263 49 8296 8297 -9264 49 8299 8300 -9265 49 8302 8303 -9266 49 8305 8306 -9267 49 8308 8309 -9268 49 8311 8312 -9269 49 8314 8315 -9270 49 8317 8318 -9271 49 8320 8321 -9272 49 8323 8324 -9273 49 8326 8327 -9274 49 8329 8330 -9275 49 8332 8333 -9276 49 8335 8336 -9277 49 8338 8339 -9278 49 8341 8342 -9279 49 8344 8345 -9280 49 8347 8348 -9281 49 8350 8351 -9282 49 8353 8354 -9283 49 8356 8357 -9284 49 8359 8360 -9285 49 8362 8363 -9286 49 8365 8366 -9287 49 8368 8369 -9288 49 8371 8372 -9289 49 8374 8375 -9290 49 8377 8378 -9291 49 8380 8381 -9292 49 8383 8384 -9293 49 8386 8387 -9294 49 8389 8390 -9295 49 8392 8393 -9296 49 8395 8396 -9297 49 8398 8399 -9298 49 8401 8402 -9299 49 8404 8405 -9300 49 8407 8408 -9301 49 8410 8411 -9302 49 8413 8414 -9303 49 8416 8417 -9304 49 8419 8420 -9305 49 8422 8423 -9306 49 8425 8426 -9307 49 8428 8429 -9308 49 8431 8432 -9309 49 8434 8435 -9310 49 8437 8438 -9311 49 8440 8441 -9312 49 8443 8444 -9313 49 8446 8447 -9314 49 8449 8450 -9315 49 8452 8453 -9316 49 8455 8456 -9317 49 8458 8459 -9318 49 8461 8462 -9319 49 8464 8465 -9320 49 8467 8468 -9321 49 8470 8471 -9322 49 8473 8474 -9323 49 8476 8477 -9324 49 8479 8480 -9325 49 8482 8483 -9326 49 8485 8486 -9327 49 8488 8489 -9328 49 8491 8492 -9329 49 8494 8495 -9330 49 8497 8498 -9331 49 8500 8501 -9332 49 8503 8504 -9333 49 8506 8507 -9334 49 8509 8510 -9335 49 8512 8513 -9336 49 8515 8516 -9337 49 8518 8519 -9338 49 8521 8522 -9339 49 8524 8525 -9340 49 8527 8528 -9341 49 8530 8531 -9342 49 8533 8534 -9343 49 8536 8537 -9344 49 8539 8540 -9345 49 8542 8543 -9346 49 8545 8546 -9347 49 8548 8549 -9348 49 8551 8552 -9349 49 8554 8555 -9350 49 8557 8558 -9351 49 8560 8561 -9352 49 8563 8564 -9353 49 8566 8567 -9354 49 8569 8570 -9355 49 8572 8573 -9356 49 8575 8576 -9357 49 8578 8579 -9358 49 8581 8582 -9359 49 8584 8585 -9360 49 8587 8588 -9361 49 8590 8591 -9362 49 8593 8594 -9363 49 8596 8597 -9364 49 8599 8600 -9365 49 8602 8603 -9366 49 8605 8606 -9367 49 8608 8609 -9368 49 8611 8612 -9369 49 8614 8615 -9370 49 8617 8618 -9371 49 8620 8621 -9372 49 8623 8624 -9373 49 8626 8627 -9374 49 8629 8630 -9375 49 8632 8633 -9376 49 8635 8636 -9377 49 8638 8639 -9378 49 8641 8642 -9379 49 8644 8645 -9380 49 8647 8648 -9381 49 8650 8651 -9382 49 8653 8654 -9383 49 8656 8657 -9384 49 8659 8660 -9385 49 8662 8663 -9386 49 8665 8666 -9387 49 8668 8669 -9388 49 8671 8672 -9389 49 8674 8675 -9390 49 8677 8678 -9391 49 8680 8681 -9392 49 8683 8684 -9393 49 8686 8687 -9394 49 8689 8690 -9395 49 8692 8693 -9396 49 8695 8696 -9397 49 8698 8699 -9398 49 8701 8702 -9399 49 8704 8705 -9400 49 8707 8708 -9401 49 8710 8711 -9402 49 8713 8714 -9403 49 8716 8717 -9404 49 8719 8720 -9405 49 8722 8723 -9406 49 8725 8726 -9407 49 8728 8729 -9408 49 8731 8732 -9409 49 8734 8735 -9410 49 8737 8738 -9411 49 8740 8741 -9412 49 8743 8744 -9413 49 8746 8747 -9414 49 8749 8750 -9415 49 8752 8753 -9416 49 8755 8756 -9417 49 8758 8759 -9418 49 8761 8762 -9419 49 8764 8765 -9420 49 8767 8768 -9421 49 8770 8771 -9422 49 8773 8774 -9423 49 8776 8777 -9424 49 8779 8780 -9425 49 8782 8783 -9426 49 8785 8786 -9427 49 8788 8789 -9428 49 8791 8792 -9429 49 8794 8795 -9430 49 8797 8798 -9431 49 8800 8801 -9432 49 8803 8804 -9433 49 8806 8807 -9434 49 8809 8810 -9435 49 8812 8813 -9436 49 8815 8816 -9437 49 8818 8819 -9438 49 8821 8822 -9439 49 8824 8825 -9440 49 8827 8828 -9441 49 8830 8831 -9442 49 8833 8834 -9443 49 8836 8837 -9444 49 8839 8840 -9445 49 8842 8843 -9446 49 8845 8846 -9447 49 8848 8849 -9448 49 8851 8852 -9449 49 8854 8855 -9450 49 8857 8858 -9451 49 8860 8861 -9452 49 8863 8864 -9453 49 8866 8867 -9454 49 8869 8870 -9455 49 8872 8873 -9456 49 8875 8876 -9457 49 8878 8879 -9458 49 8881 8882 -9459 49 8884 8885 -9460 49 8887 8888 -9461 49 8890 8891 -9462 49 8893 8894 -9463 49 8896 8897 -9464 49 8899 8900 -9465 49 8902 8903 -9466 49 8905 8906 -9467 49 8908 8909 -9468 49 8911 8912 -9469 49 8914 8915 -9470 49 8917 8918 -9471 49 8920 8921 -9472 49 8923 8924 -9473 49 8926 8927 -9474 49 8929 8930 -9475 49 8932 8933 -9476 49 8935 8936 -9477 49 8938 8939 -9478 49 8941 8942 -9479 49 8944 8945 -9480 49 8947 8948 -9481 49 8950 8951 -9482 49 8953 8954 -9483 49 8956 8957 -9484 49 8959 8960 -9485 49 8962 8963 -9486 49 8965 8966 -9487 49 8968 8969 -9488 49 8971 8972 -9489 49 8974 8975 -9490 49 8977 8978 -9491 49 8980 8981 -9492 49 8983 8984 -9493 49 8986 8987 -9494 49 8989 8990 -9495 49 8992 8993 -9496 49 8995 8996 -9497 49 8998 8999 -9498 49 9001 9002 -9499 49 9004 9005 -9500 49 9007 9008 -9501 49 9010 9011 -9502 49 9013 9014 -9503 49 9016 9017 -9504 49 9019 9020 -9505 49 9022 9023 -9506 49 9025 9026 -9507 49 9028 9029 -9508 49 9031 9032 -9509 49 9034 9035 -9510 49 9037 9038 -9511 49 9040 9041 -9512 49 9043 9044 -9513 49 9046 9047 -9514 49 9049 9050 -9515 49 9052 9053 -9516 49 9055 9056 -9517 49 9058 9059 -9518 49 9061 9062 -9519 49 9064 9065 -9520 49 9067 9068 -9521 49 9070 9071 -9522 49 9073 9074 -9523 49 9076 9077 -9524 49 9079 9080 -9525 49 9082 9083 -9526 49 9085 9086 -9527 49 9088 9089 -9528 49 9091 9092 -9529 49 9094 9095 -9530 49 9097 9098 -9531 49 9100 9101 -9532 49 9103 9104 -9533 49 9106 9107 -9534 49 9109 9110 -9535 49 9112 9113 -9536 49 9115 9116 -9537 49 9118 9119 -9538 49 9121 9122 -9539 49 9124 9125 -9540 49 9127 9128 -9541 49 9130 9131 -9542 49 9133 9134 -9543 49 9136 9137 -9544 49 9139 9140 -9545 49 9142 9143 -9546 49 9145 9146 -9547 49 9148 9149 -9548 49 9151 9152 -9549 49 9154 9155 -9550 49 9157 9158 -9551 49 9160 9161 -9552 49 9163 9164 -9553 49 9166 9167 -9554 49 9169 9170 -9555 49 9172 9173 -9556 49 9175 9176 -9557 49 9178 9179 -9558 49 9181 9182 -9559 49 9184 9185 -9560 49 9187 9188 -9561 49 9190 9191 -9562 49 9193 9194 -9563 49 9196 9197 -9564 49 9199 9200 -9565 49 9202 9203 -9566 49 9205 9206 -9567 49 9208 9209 -9568 49 9211 9212 -9569 49 9214 9215 -9570 49 9217 9218 -9571 49 9220 9221 -9572 49 9223 9224 -9573 49 9226 9227 -9574 49 9229 9230 -9575 49 9232 9233 -9576 49 9235 9236 -9577 49 9238 9239 -9578 49 9241 9242 -9579 49 9244 9245 -9580 49 9247 9248 -9581 49 9250 9251 -9582 49 9253 9254 -9583 49 9256 9257 -9584 49 9259 9260 -9585 49 9262 9263 -9586 49 9265 9266 -9587 49 9268 9269 -9588 49 9271 9272 -9589 49 9274 9275 -9590 49 9277 9278 -9591 49 9280 9281 -9592 49 9283 9284 -9593 49 9286 9287 -9594 49 9289 9290 -9595 49 9292 9293 -9596 49 9295 9296 -9597 49 9298 9299 -9598 49 9301 9302 -9599 49 9304 9305 -9600 49 9307 9308 -9601 49 9310 9311 -9602 49 9313 9314 -9603 49 9316 9317 -9604 49 9319 9320 -9605 49 9322 9323 -9606 49 9325 9326 -9607 49 9328 9329 -9608 49 9331 9332 -9609 49 9334 9335 -9610 49 9337 9338 -9611 49 9340 9341 -9612 49 9343 9344 -9613 49 9346 9347 -9614 49 9349 9350 -9615 49 9352 9353 -9616 49 9355 9356 -9617 49 9358 9359 -9618 49 9361 9362 -9619 49 9364 9365 -9620 49 9367 9368 -9621 49 9370 9371 -9622 49 9373 9374 -9623 49 9376 9377 -9624 49 9379 9380 -9625 49 9382 9383 -9626 49 9385 9386 -9627 49 9388 9389 -9628 49 9391 9392 -9629 49 9394 9395 -9630 49 9397 9398 -9631 49 9400 9401 -9632 49 9403 9404 -9633 49 9406 9407 -9634 49 9409 9410 -9635 49 9412 9413 -9636 49 9415 9416 -9637 49 9418 9419 -9638 49 9421 9422 -9639 49 9424 9425 -9640 49 9427 9428 -9641 49 9430 9431 -9642 49 9433 9434 -9643 49 9436 9437 -9644 49 9439 9440 -9645 49 9442 9443 -9646 49 9445 9446 -9647 49 9448 9449 -9648 49 9451 9452 -9649 49 9454 9455 -9650 49 9457 9458 -9651 49 9460 9461 -9652 49 9463 9464 -9653 49 9466 9467 -9654 49 9469 9470 -9655 49 9472 9473 -9656 49 9475 9476 -9657 49 9478 9479 -9658 49 9481 9482 -9659 49 9484 9485 -9660 49 9487 9488 -9661 49 9490 9491 -9662 49 9493 9494 -9663 49 9496 9497 -9664 49 9499 9500 -9665 49 9502 9503 -9666 49 9505 9506 -9667 49 9508 9509 -9668 49 9511 9512 -9669 49 9514 9515 -9670 49 9517 9518 -9671 49 9520 9521 -9672 49 9523 9524 -9673 49 9526 9527 -9674 49 9529 9530 -9675 49 9532 9533 -9676 49 9535 9536 -9677 49 9538 9539 -9678 49 9541 9542 -9679 49 9544 9545 -9680 49 9547 9548 -9681 49 9550 9551 -9682 49 9553 9554 -9683 49 9556 9557 -9684 49 9559 9560 -9685 49 9562 9563 -9686 49 9565 9566 -9687 49 9568 9569 -9688 49 9571 9572 -9689 49 9574 9575 -9690 49 9577 9578 -9691 49 9580 9581 -9692 49 9583 9584 -9693 49 9586 9587 -9694 49 9589 9590 -9695 49 9592 9593 -9696 49 9595 9596 -9697 49 9598 9599 -9698 49 9601 9602 -9699 49 9604 9605 -9700 49 9607 9608 -9701 49 9610 9611 -9702 49 9613 9614 -9703 49 9616 9617 -9704 49 9619 9620 -9705 49 9622 9623 -9706 49 9625 9626 -9707 49 9628 9629 -9708 49 9631 9632 -9709 49 9634 9635 -9710 49 9637 9638 -9711 49 9640 9641 -9712 49 9643 9644 -9713 49 9646 9647 -9714 49 9649 9650 -9715 49 9652 9653 -9716 49 9655 9656 -9717 49 9658 9659 -9718 49 9661 9662 -9719 49 9664 9665 -9720 49 9667 9668 -9721 49 9670 9671 -9722 49 9673 9674 -9723 49 9676 9677 -9724 49 9679 9680 -9725 49 9682 9683 -9726 49 9685 9686 -9727 49 9688 9689 -9728 49 9691 9692 -9729 49 9694 9695 -9730 49 9697 9698 -9731 49 9700 9701 -9732 49 9703 9704 -9733 49 9706 9707 -9734 49 9709 9710 -9735 49 9712 9713 -9736 49 9715 9716 -9737 49 9718 9719 -9738 49 9721 9722 -9739 49 9724 9725 -9740 49 9727 9728 -9741 49 9730 9731 -9742 49 9733 9734 -9743 49 9736 9737 Angles @@ -28610,121 +25775,120 @@ Bond Coeffs 46 1.081 370.5 -944.775 1405.3528125 47 1.509 345.0 -879.75 1308.628125 48 0.9572 556.85 -1419.9675 2112.20165625 -49 -7.6 1.5537 0.0 0.0 Angle Coeffs -1 0 108.5 43.2 -34.6524874495 7.94176512195 -5.68787029215 10.2422873821 -2 0 105.4 43.2 -34.6524874495 7.94176512195 -5.68787029215 10.2422873821 -3 0 110.7 75.2 -60.3209966714 13.8245541012 -9.90110754559 17.8291669244 -4 0 109.3 59.0 -47.3263138778 10.8463921804 -7.76815618604 13.9883091561 -5 0 110.7 75.2 -60.3209966714 13.8245541012 -9.90110754559 17.8291669244 -6 0 109.5 39.0 -31.2834956141 7.16964906843 -5.13488290263 9.24650944218 -7 0 110.6 58.0 -46.5241729646 10.6625550248 -7.63649252187 13.7512191704 -8 0 112.8 42.0 -33.6899183537 7.72116053523 -5.52987389514 9.95777939927 -9 1 122.4 80.0 -64.1712730547 14.7069724481 -10.5330931336 18.9671988558 -10 1 113.4 70.0 -56.1498639228 12.868600892 -9.21645649191 16.5962989988 -11 1 124.2 77.0 -61.7648503151 14.1554609813 -10.1381021411 18.2559288987 -12 0 111.0 48.2 -38.6631920154 8.86095089995 -6.346188613 11.4277373106 -13 0 110.7 42.0 -33.6899183537 7.72116053523 -5.52987389514 9.95777939927 -14 0 110.7 42.0 -33.6899183537 7.72116053523 -5.52987389514 9.95777939927 -15 0 107.8 40.0 -32.0856365273 7.35348622403 -5.2665465668 9.48359942788 -16 0 110.1 53.2 -42.6738965813 9.78013667795 -7.00450693385 12.6131872391 -17 0 110.8 53.2 -42.6738965813 9.78013667795 -7.00450693385 12.6131872391 -18 0 95.9 60.4 -48.4493111563 11.1037641983 -7.95248531587 14.3202351361 -19 0 108.0 53.2 -42.6738965813 9.78013667795 -7.00450693385 12.6131872391 -20 1 122.0 50.0 -40.1070456592 9.19185778003 -6.5831832085 11.8544992848 -21 1 121.0 36.0 -28.8770728746 6.61813760162 -4.73989191012 8.53523948509 -22 1 117.0 32.0 -25.6685092219 5.88278897922 -4.21323725344 7.5868795423 -23 0 109.6 61.0 -48.9305957042 11.2140664916 -8.03148351438 14.4624891275 -24 0 111.0 55.0 -44.1177502251 10.111043558 -7.24150152936 13.0399492133 -25 0 111.3 54.0 -43.3156093119 9.92720640244 -7.10983786519 12.8028592276 -26 0 110.6 47.6 -38.1819074675 8.75064860659 -6.2671904145 11.2854833192 -27 0 109.5 39.0 -31.2834956141 7.16964906843 -5.13488290263 9.24650944218 -28 1 122.4 80.0 -64.1712730547 14.7069724481 -10.5330931336 18.9671988558 -29 1 113.4 70.0 -56.1498639228 12.868600892 -9.21645649191 16.5962989988 -30 1 123.0 29.5 -23.6631569389 5.42319609022 -3.88407809302 6.99415457806 -31 0 111.3 54.0 -43.3156093119 9.92720640244 -7.10983786519 12.8028592276 -32 0 110.6 58.0 -46.5241729646 10.6625550248 -7.63649252187 13.7512191704 -33 0 110.7 42.0 -33.6899183537 7.72116053523 -5.52987389514 9.95777939927 -34 0 110.2 48.2 -38.6631920154 8.86095089995 -6.346188613 11.4277373106 -35 0 110.2 48.2 -38.6631920154 8.86095089995 -6.346188613 11.4277373106 -36 0 110.6 38.9 -31.2032815228 7.15126535287 -5.12171653622 9.22280044361 -37 0 109.3 39.6 -31.7647801621 7.27995136179 -5.21388110114 9.3887634336 -38 1 122.3 33.8 -27.1123628656 6.2136958593 -4.45023184895 8.01364151656 -39 1 121.7 54.7 -43.8771079511 10.0558924114 -7.2020024301 12.9688222176 -40 1 120.0 35.3 -28.3155742354 6.4894515927 -4.6477273452 8.3692764951 -41 0 111.0 48.2 -38.6631920154 8.86095089995 -6.346188613 11.4277373106 -42 0 109.5 56.1 -45.0001052296 10.3132644292 -7.38633155994 13.3007481976 -43 0 109.3 59.0 -47.3263138778 10.8463921804 -7.76815618604 13.9883091561 -44 0 110.9 43.2 -34.6524874495 7.94176512195 -5.68787029215 10.2422873821 -45 0 107.0 43.5 -34.8931297235 7.99691626863 -5.7273693914 10.3134143778 -46 0 107.5 59.7 -47.887812517 10.9750781894 -7.86032075095 14.1542721461 -47 0 107.5 59.7 -47.887812517 10.9750781894 -7.86032075095 14.1542721461 -48 0 110.0 59.0 -47.3263138778 10.8463921804 -7.76815618604 13.9883091561 -49 0 106.8 54.0 -43.3156093119 9.92720640244 -7.10983786519 12.8028592276 -50 0 111.0 48.2 -38.6631920154 8.86095089995 -6.346188613 11.4277373106 -51 1 122.0 50.0 -40.1070456592 9.19185778003 -6.5831832085 11.8544992848 -52 1 117.0 32.0 -25.6685092219 5.88278897922 -4.21323725344 7.5868795423 -53 0 109.8 55.0 -44.1177502251 10.111043558 -7.24150152936 13.0399492133 -54 0 111.0 55.0 -44.1177502251 10.111043558 -7.24150152936 13.0399492133 -55 0 109.5 39.0 -31.2834956141 7.16964906843 -5.13488290263 9.24650944218 -56 0 107.6 40.0 -32.0856365273 7.35348622403 -5.2665465668 9.48359942788 -57 1 122.4 80.0 -64.1712730547 14.7069724481 -10.5330931336 18.9671988558 -58 1 113.4 70.0 -56.1498639228 12.868600892 -9.21645649191 16.5962989988 -59 0 110.6 47.6 -38.1819074675 8.75064860659 -6.2671904145 11.2854833192 -60 0 109.5 39.0 -31.2834956141 7.16964906843 -5.13488290263 9.24650944218 -61 1 122.4 80.0 -64.1712730547 14.7069724481 -10.5330931336 18.9671988558 -62 1 134.0 57.6 -46.2033165993 10.5890201626 -7.5838270562 13.6563831761 -63 1 113.4 70.0 -56.1498639228 12.868600892 -9.21645649191 16.5962989988 -64 1 124.2 77.0 -61.7648503151 14.1554609813 -10.1381021411 18.2559288987 -65 1 122.0 50.0 -40.1070456592 9.19185778003 -6.5831832085 11.8544992848 -66 1 122.0 50.0 -40.1070456592 9.19185778003 -6.5831832085 11.8544992848 -67 1 112.5 54.7 -43.8771079511 10.0558924114 -7.2020024301 12.9688222176 -68 0 109.6 61.0 -48.9305957042 11.2140664916 -8.03148351438 14.4624891275 -69 0 111.0 55.0 -44.1177502251 10.111043558 -7.24150152936 13.0399492133 -70 0 104.0 54.0 -43.3156093119 9.92720640244 -7.10983786519 12.8028592276 -71 0 110.6 58.0 -46.5241729646 10.6625550248 -7.63649252187 13.7512191704 -72 0 112.8 42.0 -33.6899183537 7.72116053523 -5.52987389514 9.95777939927 -73 0 104.0 48.2 -38.6631920154 8.86095089995 -6.346188613 11.4277373106 -74 0 110.7 42.0 -33.6899183537 7.72116053523 -5.52987389514 9.95777939927 -75 0 110.7 42.0 -33.6899183537 7.72116053523 -5.52987389514 9.95777939927 -76 0 107.8 40.0 -32.0856365273 7.35348622403 -5.2665465668 9.48359942788 -77 0 104.0 48.2 -38.6631920154 8.86095089995 -6.346188613 11.4277373106 -78 0 104.0 54.0 -43.3156093119 9.92720640244 -7.10983786519 12.8028592276 -79 0 111.0 55.0 -44.1177502251 10.111043558 -7.24150152936 13.0399492133 -80 0 110.7 42.0 -33.6899183537 7.72116053523 -5.52987389514 9.95777939927 -81 0 107.8 40.0 -32.0856365273 7.35348622403 -5.2665465668 9.48359942788 -82 0 107.5 59.7 -47.887812517 10.9750781894 -7.86032075095 14.1542721461 -83 0 108.9 59.0 -47.3263138778 10.8463921804 -7.76815618604 13.9883091561 -84 0 106.8 54.0 -43.3156093119 9.92720640244 -7.10983786519 12.8028592276 -85 0 110.6 47.6 -38.1819074675 8.75064860659 -6.2671904145 11.2854833192 -86 0 110.6 47.6 -38.1819074675 8.75064860659 -6.2671904145 11.2854833192 -87 0 109.5 56.1 -45.0001052296 10.3132644292 -7.38633155994 13.3007481976 -88 0 111.0 54.6 -43.7968938598 10.0375086958 -7.18883606369 12.9451132191 -89 1 120.4 52.5 -42.1123979421 9.65145066903 -6.91234236893 12.4472242491 -90 1 122.4 13.7 -10.9893305106 2.51856903173 -1.80379219913 3.24813280405 -91 1 120.5 41.7 -33.4492760797 7.66600938855 -5.49037479589 9.88665240356 -92 1 120.0 28.8 -23.1016582997 5.2945100813 -3.7919135281 6.82819158807 -93 1 120.0 29.5 -23.6631569389 5.42319609022 -3.88407809302 6.99415457806 -94 1 120.0 43.2 -34.6524874495 7.94176512195 -5.68787029215 10.2422873821 -95 0 109.0 25.9 -20.7754496514 4.76138233006 -3.41008890201 6.14063062955 -96 0 112.7 38.8 -31.1230674315 7.13288163731 -5.1085501698 9.19909144504 -97 0 109.5 39.6 -31.7647801621 7.27995136179 -5.21388110114 9.3887634336 -98 1 122.0 36.0 -28.8770728746 6.61813760162 -4.73989191012 8.53523948509 -99 1 131.0 36.0 -28.8770728746 6.61813760162 -4.73989191012 8.53523948509 -100 1 104.7 47.5 -38.1016933762 8.73226489103 -6.25402404808 11.2617743206 -101 1 110.8 86.3 -69.2247608077 15.8651465283 -11.3625742179 20.4608657656 -102 1 125.5 35.3 -28.3155742354 6.4894515927 -4.6477273452 8.3692764951 -103 1 125.5 35.3 -28.3155742354 6.4894515927 -4.6477273452 8.3692764951 -104 1 128.0 35.3 -28.3155742354 6.4894515927 -4.6477273452 8.3692764951 -105 1 122.5 38.1 -30.5615687923 7.00419562839 -5.01638560488 9.03312845505 -106 1 110.3 28.8 -23.1016582997 5.2945100813 -3.7919135281 6.82819158807 -107 1 122.5 38.1 -30.5615687923 7.00419562839 -5.01638560488 9.03312845505 -108 0 109.6 61.0 -48.9305957042 11.2140664916 -8.03148351438 14.4624891275 -109 0 109.5 39.0 -31.2834956141 7.16964906843 -5.13488290263 9.24650944218 -110 1 122.4 80.0 -64.1712730547 14.7069724481 -10.5330931336 18.9671988558 -111 0 108.5 48.7 -39.064262472 8.95286947775 -6.41202044508 11.5462823034 +1 0 0 108.5 43.2 -34.6524874495 7.94176512195 -5.68787029215 10.2422873821 +2 0 0 105.4 43.2 -34.6524874495 7.94176512195 -5.68787029215 10.2422873821 +3 0 0 110.7 75.2 -60.3209966714 13.8245541012 -9.90110754559 17.8291669244 +4 0 0 109.3 59.0 -47.3263138778 10.8463921804 -7.76815618604 13.9883091561 +5 0 0 110.7 75.2 -60.3209966714 13.8245541012 -9.90110754559 17.8291669244 +6 0 0 109.5 39.0 -31.2834956141 7.16964906843 -5.13488290263 9.24650944218 +7 0 0 110.6 58.0 -46.5241729646 10.6625550248 -7.63649252187 13.7512191704 +8 0 0 112.8 42.0 -33.6899183537 7.72116053523 -5.52987389514 9.95777939927 +9 1 0 122.4 80.0 -64.1712730547 14.7069724481 -10.5330931336 18.9671988558 +10 1 0 113.4 70.0 -56.1498639228 12.868600892 -9.21645649191 16.5962989988 +11 1 0 124.2 77.0 -61.7648503151 14.1554609813 -10.1381021411 18.2559288987 +12 0 0 111.0 48.2 -38.6631920154 8.86095089995 -6.346188613 11.4277373106 +13 0 0 110.7 42.0 -33.6899183537 7.72116053523 -5.52987389514 9.95777939927 +14 0 0 110.7 42.0 -33.6899183537 7.72116053523 -5.52987389514 9.95777939927 +15 0 0 107.8 40.0 -32.0856365273 7.35348622403 -5.2665465668 9.48359942788 +16 0 0 110.1 53.2 -42.6738965813 9.78013667795 -7.00450693385 12.6131872391 +17 0 0 110.8 53.2 -42.6738965813 9.78013667795 -7.00450693385 12.6131872391 +18 0 0 95.9 60.4 -48.4493111563 11.1037641983 -7.95248531587 14.3202351361 +19 0 0 108.0 53.2 -42.6738965813 9.78013667795 -7.00450693385 12.6131872391 +20 1 0 122.0 50.0 -40.1070456592 9.19185778003 -6.5831832085 11.8544992848 +21 1 0 121.0 36.0 -28.8770728746 6.61813760162 -4.73989191012 8.53523948509 +22 1 0 117.0 32.0 -25.6685092219 5.88278897922 -4.21323725344 7.5868795423 +23 0 0 109.6 61.0 -48.9305957042 11.2140664916 -8.03148351438 14.4624891275 +24 0 0 111.0 55.0 -44.1177502251 10.111043558 -7.24150152936 13.0399492133 +25 0 0 111.3 54.0 -43.3156093119 9.92720640244 -7.10983786519 12.8028592276 +26 0 0 110.6 47.6 -38.1819074675 8.75064860659 -6.2671904145 11.2854833192 +27 0 0 109.5 39.0 -31.2834956141 7.16964906843 -5.13488290263 9.24650944218 +28 1 0 122.4 80.0 -64.1712730547 14.7069724481 -10.5330931336 18.9671988558 +29 1 0 113.4 70.0 -56.1498639228 12.868600892 -9.21645649191 16.5962989988 +30 1 0 123.0 29.5 -23.6631569389 5.42319609022 -3.88407809302 6.99415457806 +31 0 0 111.3 54.0 -43.3156093119 9.92720640244 -7.10983786519 12.8028592276 +32 0 0 110.6 58.0 -46.5241729646 10.6625550248 -7.63649252187 13.7512191704 +33 0 0 110.7 42.0 -33.6899183537 7.72116053523 -5.52987389514 9.95777939927 +34 0 0 110.2 48.2 -38.6631920154 8.86095089995 -6.346188613 11.4277373106 +35 0 0 110.2 48.2 -38.6631920154 8.86095089995 -6.346188613 11.4277373106 +36 0 0 110.6 38.9 -31.2032815228 7.15126535287 -5.12171653622 9.22280044361 +37 0 0 109.3 39.6 -31.7647801621 7.27995136179 -5.21388110114 9.3887634336 +38 1 0 122.3 33.8 -27.1123628656 6.2136958593 -4.45023184895 8.01364151656 +39 1 0 121.7 54.7 -43.8771079511 10.0558924114 -7.2020024301 12.9688222176 +40 1 0 120.0 35.3 -28.3155742354 6.4894515927 -4.6477273452 8.3692764951 +41 0 0 111.0 48.2 -38.6631920154 8.86095089995 -6.346188613 11.4277373106 +42 0 0 109.5 56.1 -45.0001052296 10.3132644292 -7.38633155994 13.3007481976 +43 0 0 109.3 59.0 -47.3263138778 10.8463921804 -7.76815618604 13.9883091561 +44 0 0 110.9 43.2 -34.6524874495 7.94176512195 -5.68787029215 10.2422873821 +45 0 0 107.0 43.5 -34.8931297235 7.99691626863 -5.7273693914 10.3134143778 +46 0 0 107.5 59.7 -47.887812517 10.9750781894 -7.86032075095 14.1542721461 +47 0 0 107.5 59.7 -47.887812517 10.9750781894 -7.86032075095 14.1542721461 +48 0 0 110.0 59.0 -47.3263138778 10.8463921804 -7.76815618604 13.9883091561 +49 0 0 106.8 54.0 -43.3156093119 9.92720640244 -7.10983786519 12.8028592276 +50 0 0 111.0 48.2 -38.6631920154 8.86095089995 -6.346188613 11.4277373106 +51 1 0 122.0 50.0 -40.1070456592 9.19185778003 -6.5831832085 11.8544992848 +52 1 0 117.0 32.0 -25.6685092219 5.88278897922 -4.21323725344 7.5868795423 +53 0 0 109.8 55.0 -44.1177502251 10.111043558 -7.24150152936 13.0399492133 +54 0 0 111.0 55.0 -44.1177502251 10.111043558 -7.24150152936 13.0399492133 +55 0 0 109.5 39.0 -31.2834956141 7.16964906843 -5.13488290263 9.24650944218 +56 0 0 107.6 40.0 -32.0856365273 7.35348622403 -5.2665465668 9.48359942788 +57 1 0 122.4 80.0 -64.1712730547 14.7069724481 -10.5330931336 18.9671988558 +58 1 0 113.4 70.0 -56.1498639228 12.868600892 -9.21645649191 16.5962989988 +59 0 0 110.6 47.6 -38.1819074675 8.75064860659 -6.2671904145 11.2854833192 +60 0 0 109.5 39.0 -31.2834956141 7.16964906843 -5.13488290263 9.24650944218 +61 1 0 122.4 80.0 -64.1712730547 14.7069724481 -10.5330931336 18.9671988558 +62 1 0 134.0 57.6 -46.2033165993 10.5890201626 -7.5838270562 13.6563831761 +63 1 0 113.4 70.0 -56.1498639228 12.868600892 -9.21645649191 16.5962989988 +64 1 0 124.2 77.0 -61.7648503151 14.1554609813 -10.1381021411 18.2559288987 +65 1 0 122.0 50.0 -40.1070456592 9.19185778003 -6.5831832085 11.8544992848 +66 1 0 122.0 50.0 -40.1070456592 9.19185778003 -6.5831832085 11.8544992848 +67 1 0 112.5 54.7 -43.8771079511 10.0558924114 -7.2020024301 12.9688222176 +68 0 0 109.6 61.0 -48.9305957042 11.2140664916 -8.03148351438 14.4624891275 +69 0 0 111.0 55.0 -44.1177502251 10.111043558 -7.24150152936 13.0399492133 +70 0 0 104.0 54.0 -43.3156093119 9.92720640244 -7.10983786519 12.8028592276 +71 0 0 110.6 58.0 -46.5241729646 10.6625550248 -7.63649252187 13.7512191704 +72 0 0 112.8 42.0 -33.6899183537 7.72116053523 -5.52987389514 9.95777939927 +73 0 0 104.0 48.2 -38.6631920154 8.86095089995 -6.346188613 11.4277373106 +74 0 0 110.7 42.0 -33.6899183537 7.72116053523 -5.52987389514 9.95777939927 +75 0 0 110.7 42.0 -33.6899183537 7.72116053523 -5.52987389514 9.95777939927 +76 0 0 107.8 40.0 -32.0856365273 7.35348622403 -5.2665465668 9.48359942788 +77 0 0 104.0 48.2 -38.6631920154 8.86095089995 -6.346188613 11.4277373106 +78 0 0 104.0 54.0 -43.3156093119 9.92720640244 -7.10983786519 12.8028592276 +79 0 0 111.0 55.0 -44.1177502251 10.111043558 -7.24150152936 13.0399492133 +80 0 0 110.7 42.0 -33.6899183537 7.72116053523 -5.52987389514 9.95777939927 +81 0 0 107.8 40.0 -32.0856365273 7.35348622403 -5.2665465668 9.48359942788 +82 0 0 107.5 59.7 -47.887812517 10.9750781894 -7.86032075095 14.1542721461 +83 0 0 108.9 59.0 -47.3263138778 10.8463921804 -7.76815618604 13.9883091561 +84 0 0 106.8 54.0 -43.3156093119 9.92720640244 -7.10983786519 12.8028592276 +85 0 0 110.6 47.6 -38.1819074675 8.75064860659 -6.2671904145 11.2854833192 +86 0 0 110.6 47.6 -38.1819074675 8.75064860659 -6.2671904145 11.2854833192 +87 0 0 109.5 56.1 -45.0001052296 10.3132644292 -7.38633155994 13.3007481976 +88 0 0 111.0 54.6 -43.7968938598 10.0375086958 -7.18883606369 12.9451132191 +89 1 0 120.4 52.5 -42.1123979421 9.65145066903 -6.91234236893 12.4472242491 +90 1 0 122.4 13.7 -10.9893305106 2.51856903173 -1.80379219913 3.24813280405 +91 1 0 120.5 41.7 -33.4492760797 7.66600938855 -5.49037479589 9.88665240356 +92 1 0 120.0 28.8 -23.1016582997 5.2945100813 -3.7919135281 6.82819158807 +93 1 0 120.0 29.5 -23.6631569389 5.42319609022 -3.88407809302 6.99415457806 +94 1 0 120.0 43.2 -34.6524874495 7.94176512195 -5.68787029215 10.2422873821 +95 0 0 109.0 25.9 -20.7754496514 4.76138233006 -3.41008890201 6.14063062955 +96 0 0 112.7 38.8 -31.1230674315 7.13288163731 -5.1085501698 9.19909144504 +97 0 0 109.5 39.6 -31.7647801621 7.27995136179 -5.21388110114 9.3887634336 +98 1 0 122.0 36.0 -28.8770728746 6.61813760162 -4.73989191012 8.53523948509 +99 1 0 131.0 36.0 -28.8770728746 6.61813760162 -4.73989191012 8.53523948509 +100 1 0 104.7 47.5 -38.1016933762 8.73226489103 -6.25402404808 11.2617743206 +101 1 0 110.8 86.3 -69.2247608077 15.8651465283 -11.3625742179 20.4608657656 +102 1 0 125.5 35.3 -28.3155742354 6.4894515927 -4.6477273452 8.3692764951 +103 1 0 125.5 35.3 -28.3155742354 6.4894515927 -4.6477273452 8.3692764951 +104 1 0 128.0 35.3 -28.3155742354 6.4894515927 -4.6477273452 8.3692764951 +105 1 0 122.5 38.1 -30.5615687923 7.00419562839 -5.01638560488 9.03312845505 +106 1 0 110.3 28.8 -23.1016582997 5.2945100813 -3.7919135281 6.82819158807 +107 1 0 122.5 38.1 -30.5615687923 7.00419562839 -5.01638560488 9.03312845505 +108 0 0 109.6 61.0 -48.9305957042 11.2140664916 -8.03148351438 14.4624891275 +109 0 0 109.5 39.0 -31.2834956141 7.16964906843 -5.13488290263 9.24650944218 +110 1 0 122.4 80.0 -64.1712730547 14.7069724481 -10.5330931336 18.9671988558 +111 0 1 108.5 48.7 -39.064262472 8.95286947775 -6.41202044508 11.5462823034 Dihedral Coeffs @@ -29067,3 +26231,117 @@ BondAngle Coeffs 109 11.5 11.5 1.112 1.509 110 18.7 18.7 1.509 1.2553 111 0.0 0.0 0.0 0.0 + +UreyBradley Coeffs + +1 0.0 0.0 +2 0.0 0.0 +3 0.0 0.0 +4 0.0 0.0 +5 0.0 0.0 +6 0.0 0.0 +7 0.0 0.0 +8 0.0 0.0 +9 0.0 0.0 +10 0.0 0.0 +11 0.0 0.0 +12 0.0 0.0 +13 0.0 0.0 +14 0.0 0.0 +15 0.0 0.0 +16 0.0 0.0 +17 0.0 0.0 +18 0.0 0.0 +19 0.0 0.0 +20 0.0 0.0 +21 0.0 0.0 +22 0.0 0.0 +23 0.0 0.0 +24 0.0 0.0 +25 0.0 0.0 +26 0.0 0.0 +27 0.0 0.0 +28 0.0 0.0 +29 0.0 0.0 +30 0.0 0.0 +31 0.0 0.0 +32 0.0 0.0 +33 0.0 0.0 +34 0.0 0.0 +35 0.0 0.0 +36 0.0 0.0 +37 0.0 0.0 +38 0.0 0.0 +39 0.0 0.0 +40 0.0 0.0 +41 0.0 0.0 +42 0.0 0.0 +43 0.0 0.0 +44 0.0 0.0 +45 0.0 0.0 +46 0.0 0.0 +47 0.0 0.0 +48 0.0 0.0 +49 0.0 0.0 +50 0.0 0.0 +51 0.0 0.0 +52 0.0 0.0 +53 0.0 0.0 +54 0.0 0.0 +55 0.0 0.0 +56 0.0 0.0 +57 0.0 0.0 +58 0.0 0.0 +59 0.0 0.0 +60 0.0 0.0 +61 0.0 0.0 +62 0.0 0.0 +63 0.0 0.0 +64 0.0 0.0 +65 0.0 0.0 +66 0.0 0.0 +67 0.0 0.0 +68 0.0 0.0 +69 0.0 0.0 +70 0.0 0.0 +71 0.0 0.0 +72 0.0 0.0 +73 0.0 0.0 +74 0.0 0.0 +75 0.0 0.0 +76 0.0 0.0 +77 0.0 0.0 +78 0.0 0.0 +79 0.0 0.0 +80 0.0 0.0 +81 0.0 0.0 +82 0.0 0.0 +83 0.0 0.0 +84 0.0 0.0 +85 0.0 0.0 +86 0.0 0.0 +87 0.0 0.0 +88 0.0 0.0 +89 0.0 0.0 +90 0.0 0.0 +91 0.0 0.0 +92 0.0 0.0 +93 0.0 0.0 +94 0.0 0.0 +95 0.0 0.0 +96 0.0 0.0 +97 0.0 0.0 +98 0.0 0.0 +99 0.0 0.0 +100 0.0 0.0 +101 0.0 0.0 +102 0.0 0.0 +103 0.0 0.0 +104 0.0 0.0 +105 0.0 0.0 +106 0.0 0.0 +107 0.0 0.0 +108 0.0 0.0 +109 0.0 0.0 +110 0.0 0.0 +111 -7.6 1.5537 diff --git a/examples/amoeba/data.ubiquitin.ub b/examples/amoeba/data.ubiquitin.ub new file mode 100644 index 0000000000..361291cdd4 --- /dev/null +++ b/examples/amoeba/data.ubiquitin.ub @@ -0,0 +1,29069 @@ +LAMMPS data file created from Tinker ubiquitin.xyz and amoeba_ubiquitin.prm files + +9737 atoms +9743 bonds +5094 angles +3297 dihedrals +651 impropers +6 atom types +49 bond types +111 angle types +189 dihedral types +33 improper types +0 54.99 xlo xhi +0 41.91 ylo yhi +0 41.91 zlo zhi + +Masses + +1 14.003 +2 12.0 +3 15.995 +4 1.008 +5 31.972 +6 15.999 + +Atoms + +1 1 1 0 9.963103 5.604761 0.008413 +2 1 2 0 9.595854 5.616857 -1.387669 +3 1 2 0 8.190092 6.079015 -1.537478 +4 1 3 0 7.228002 5.276741 -1.343729 +5 1 4 0 9.248539 5.324856 0.671238 +6 1 4 0 10.310756 6.543175 0.309331 +7 1 4 0 10.709289 4.952168 0.170763 +8 1 4 0 10.342605 6.385672 -1.876827 +9 1 2 0 9.777424 4.134312 -1.928716 +10 1 2 0 9.485635 3.817581 -3.412559 +11 1 5 0 10.117567 2.116666 -3.905314 +12 1 2 0 9.214556 1.102048 -2.698793 +13 1 4 0 8.995937 3.481218 -1.313618 +14 1 4 0 10.813555 3.756529 -1.729292 +15 1 4 0 10.074410 4.479912 -4.109344 +16 1 4 0 8.425285 3.844015 -3.623677 +17 1 4 0 9.476005 1.466410 -1.683717 +18 1 4 0 9.531462 0.065851 -2.728696 +19 1 4 0 8.157703 1.221346 -2.837348 +20 1 1 0 8.075651 7.407997 -1.589694 +21 1 2 0 6.846787 8.085212 -1.711474 +22 1 2 0 6.189365 7.484141 -3.005186 +23 1 3 0 6.734597 7.675309 -4.068223 +24 1 4 0 8.951370 7.929371 -1.808185 +25 1 4 0 6.170991 7.786742 -0.821099 +26 1 2 0 7.045430 9.684350 -1.731240 +27 1 2 0 5.783147 10.543682 -1.755861 +28 1 2 0 4.878227 10.489051 -3.011941 +29 1 3 0 5.100354 11.293553 -3.954911 +30 1 1 0 3.787647 9.697542 -2.965312 +31 1 4 0 7.774130 9.919050 -2.476360 +32 1 4 0 7.651586 10.027873 -0.831299 +33 1 4 0 6.211664 11.592747 -1.874653 +34 1 4 0 5.241990 10.447103 -0.794638 +35 1 4 0 3.649816 9.134508 -2.112027 +36 1 4 0 3.185263 9.534971 -3.811678 +37 1 1 0 5.036494 6.768214 -2.882880 +38 1 2 0 4.174197 6.305367 -3.990075 +39 1 2 0 2.728098 6.643573 -3.679890 +40 1 3 0 2.485580 7.278505 -2.662964 +41 1 4 0 4.569007 6.922928 -2.037115 +42 1 4 0 4.411152 6.930990 -4.873795 +43 1 2 0 4.308955 4.772244 -4.223706 +44 1 2 0 3.611944 3.837131 -3.115456 +45 1 2 0 5.819814 4.327532 -4.394409 +46 1 2 0 3.741844 2.375632 -3.462760 +47 1 4 0 3.791883 4.511448 -5.208449 +48 1 4 0 2.547744 4.084411 -3.073934 +49 1 4 0 4.014866 4.138283 -2.115089 +50 1 4 0 6.389594 4.495961 -3.449963 +51 1 4 0 6.367709 4.976173 -5.128547 +52 1 4 0 5.908880 3.195479 -4.756566 +53 1 4 0 3.393827 2.185310 -4.536109 +54 1 4 0 3.102312 1.694874 -2.887955 +55 1 4 0 4.760146 2.000072 -3.426085 +56 1 1 0 1.684147 6.367185 -4.575190 +57 1 2 0 0.304736 6.655628 -4.231748 +58 1 2 0 -0.626185 5.414986 -4.519968 +59 1 3 0 -0.188430 4.481000 -5.239972 +60 1 4 0 1.811341 5.682101 -5.345446 +61 1 4 0 0.263980 6.686032 -3.118862 +62 1 2 0 -0.297187 7.876289 -4.967331 +63 1 2 0 0.656467 9.081574 -5.199077 +64 1 2 0 1.564880 9.231158 -6.344247 +65 1 2 0 0.518242 10.180719 -4.311011 +66 1 2 0 2.254905 10.428397 -6.564398 +67 1 2 0 1.266077 11.295338 -4.552651 +68 1 2 0 2.142006 11.455092 -5.583064 +69 1 4 0 -1.140556 8.280905 -4.296048 +70 1 4 0 -0.810414 7.566064 -5.884866 +71 1 4 0 1.670266 8.406033 -7.077975 +72 1 4 0 -0.165699 10.178758 -3.490791 +73 1 4 0 2.904650 10.539850 -7.451626 +74 1 4 0 1.204400 12.095766 -3.710976 +75 1 4 0 2.760015 12.463610 -5.750178 +76 1 1 0 -1.919463 5.547799 -4.105657 +77 1 2 0 -3.045010 4.631011 -4.380927 +78 1 2 0 -4.206191 5.442932 -4.923986 +79 1 3 0 -4.727895 6.299647 -4.174539 +80 1 4 0 -2.189033 6.454364 -3.576690 +81 1 4 0 -2.684685 3.831124 -5.207150 +82 1 2 0 -3.444418 3.799031 -3.130661 +83 1 2 0 -4.638073 2.796605 -3.426800 +84 1 2 0 -2.172636 3.025555 -2.692910 +85 1 4 0 -3.669812 4.518348 -2.290701 +86 1 4 0 -4.428840 2.137544 -4.376863 +87 1 4 0 -5.534299 3.436652 -3.543248 +88 1 4 0 -4.789185 2.176325 -2.494354 +89 1 4 0 -1.667617 3.522055 -1.846039 +90 1 4 0 -1.416445 2.861139 -3.471806 +91 1 4 0 -2.413054 1.986644 -2.328475 +92 1 1 0 -4.550673 5.196731 -6.274871 +93 1 2 0 -5.820881 5.714130 -6.792896 +94 1 2 0 -6.901797 4.657281 -6.559257 +95 1 3 0 -6.707326 3.538748 -6.976520 +96 1 4 0 -4.247417 4.330282 -6.731623 +97 1 4 0 -6.018895 6.628095 -6.157881 +98 1 2 0 -5.786797 6.030910 -8.386430 +99 1 2 0 -7.031253 6.879587 -8.916479 +100 1 2 0 -6.946629 7.328107 -10.409836 +101 1 2 0 -6.782582 6.224048 -11.537592 +102 1 1 0 -6.791739 6.775547 -12.918869 +103 1 4 0 -5.650656 5.119864 -8.896094 +104 1 4 0 -4.894535 6.632893 -8.720825 +105 1 4 0 -7.188700 7.743879 -8.218707 +106 1 4 0 -7.899583 6.225721 -8.760371 +107 1 4 0 -5.985957 7.986594 -10.510771 +108 1 4 0 -7.792216 7.961266 -10.639952 +109 1 4 0 -7.448325 5.332480 -11.448147 +110 1 4 0 -5.800269 5.666745 -11.336805 +111 1 4 0 -5.991776 7.279636 -13.178670 +112 1 4 0 -7.621495 7.404931 -13.058222 +113 1 4 0 -6.983504 6.085979 -13.693073 +114 1 1 0 -8.069363 5.037776 -5.939754 +115 1 2 0 -9.334342 4.259320 -5.870215 +116 1 2 0 -10.106400 4.390027 -7.235984 +117 1 3 0 -9.678872 5.138872 -8.064541 +118 1 4 0 -8.065341 5.988423 -5.484094 +119 1 4 0 -9.057846 3.167719 -5.835950 +120 1 2 0 -10.266512 4.660993 -4.660344 +121 1 3 0 -10.534149 6.114601 -4.706758 +122 1 2 0 -9.745157 4.269631 -3.191928 +123 1 4 0 -11.263017 4.131676 -4.781723 +124 1 4 0 -9.713871 6.599029 -4.391676 +125 1 4 0 -9.116723 4.972749 -2.508566 +126 1 4 0 -9.168034 3.361328 -3.330127 +127 1 4 0 -10.522836 3.973872 -2.499829 +128 1 1 0 -11.233860 3.687218 -7.306137 +129 1 2 0 -12.200193 3.653311 -8.374575 +130 1 2 0 -13.220650 4.788154 -8.169599 +131 1 3 0 -13.737841 5.372844 -9.165473 +132 1 4 0 -11.460538 2.988105 -6.540266 +133 1 4 0 -11.637688 3.949136 -9.406377 +134 1 2 0 -12.914543 2.186268 -8.423705 +135 1 2 0 -12.050888 0.859767 -8.189045 +136 1 2 0 -12.754212 -0.443223 -8.481524 +137 1 2 0 -10.761720 0.854864 -8.962914 +138 1 4 0 -13.378342 2.203311 -9.441391 +139 1 4 0 -13.731396 2.273518 -7.697910 +140 1 4 0 -11.784384 0.837730 -7.097584 +141 1 4 0 -12.178199 -1.386252 -8.511713 +142 1 4 0 -13.030296 -0.361584 -9.541647 +143 1 4 0 -13.665537 -0.574300 -7.888432 +144 1 4 0 -10.907312 0.853311 -10.020395 +145 1 4 0 -10.166450 -0.087962 -8.625340 +146 1 4 0 -10.131655 1.808766 -8.717686 +147 1 1 0 -13.463568 5.196109 -6.936262 +148 1 2 0 -14.321525 6.337206 -6.640073 +149 1 2 0 -13.602436 7.749411 -6.813046 +150 1 3 0 -14.285287 8.753093 -7.068264 +151 1 4 0 -13.224563 4.686522 -6.108713 +152 1 4 0 -15.116925 6.447123 -7.471724 +153 1 2 0 -15.130805 6.126006 -5.300665 +154 1 3 0 -14.245708 5.884444 -4.246742 +155 1 2 0 -16.085304 4.854769 -5.370470 +156 1 4 0 -15.668029 7.073411 -5.139360 +157 1 4 0 -13.863528 6.745981 -4.031876 +158 1 4 0 -16.931480 4.985645 -6.114646 +159 1 4 0 -16.633409 4.776539 -4.392875 +160 1 4 0 -15.447009 3.996959 -5.527187 +161 1 1 0 -12.255780 7.804163 -6.773987 +162 1 2 0 -11.475822 9.029360 -6.961862 +163 1 2 0 -10.482668 9.429993 -5.875126 +164 1 3 0 -9.615012 10.212498 -6.150085 +165 1 4 0 -11.791631 6.946169 -6.476230 +166 1 4 0 -10.849439 8.869550 -7.825758 +167 1 4 0 -12.070294 9.912283 -7.089554 +168 1 1 0 -10.710240 8.937450 -4.551265 +169 1 2 0 -9.795182 9.275190 -3.486218 +170 1 2 0 -8.432503 8.733444 -3.903900 +171 1 3 0 -8.256860 7.497941 -4.141932 +172 1 4 0 -11.613017 8.458729 -4.378865 +173 1 4 0 -9.758201 10.415786 -3.586213 +174 1 2 0 -10.207682 8.847560 -2.068515 +175 1 2 0 -9.468868 9.640494 -0.969458 +176 1 2 0 -9.960726 11.106750 -0.880514 +177 1 2 0 -8.996147 11.882980 0.056845 +178 1 1 0 -9.422979 13.246330 0.389189 +179 1 4 0 -10.025076 7.711214 -1.993654 +180 1 4 0 -11.260829 8.969143 -1.909413 +181 1 4 0 -8.357381 9.561485 -1.037070 +182 1 4 0 -9.831062 9.156523 0.052119 +183 1 4 0 -10.951565 11.152527 -0.421834 +184 1 4 0 -10.025528 11.645570 -1.861235 +185 1 4 0 -7.996392 12.007902 -0.493686 +186 1 4 0 -8.903714 11.241749 1.019391 +187 1 4 0 -9.372439 13.931515 -0.356496 +188 1 4 0 -8.869279 13.642636 1.216690 +189 1 4 0 -10.417962 13.346471 0.725918 +190 1 1 0 -7.417712 9.626751 -3.887457 +191 1 2 0 -6.048686 9.319758 -4.265281 +192 1 2 0 -5.195256 9.655954 -3.012996 +193 1 3 0 -5.383682 10.790154 -2.469855 +194 1 4 0 -7.536192 10.638944 -3.603417 +195 1 4 0 -5.899497 8.237555 -4.489940 +196 1 2 0 -5.632346 10.139153 -5.558621 +197 1 3 0 -6.651850 9.845307 -6.610520 +198 1 2 0 -4.307909 9.733791 -6.252541 +199 1 4 0 -5.546957 11.240303 -5.391676 +200 1 4 0 -7.479446 10.239776 -6.352124 +201 1 4 0 -4.057722 10.346459 -7.141293 +202 1 4 0 -4.216816 8.651918 -6.414903 +203 1 4 0 -3.513698 9.947681 -5.542599 +204 1 1 0 -4.487761 8.698281 -2.479508 +205 1 2 0 -3.941682 8.719222 -1.101838 +206 1 2 0 -2.471661 8.338585 -1.186861 +207 1 3 0 -2.098577 7.337481 -1.795680 +208 1 4 0 -4.371107 7.734334 -2.775858 +209 1 4 0 -3.985516 9.750968 -0.737465 +210 1 2 0 -4.697768 7.852820 -0.064484 +211 1 2 0 -4.708913 6.295035 -0.438982 +212 1 2 0 -6.123205 8.316839 0.212195 +213 1 2 0 -5.620903 5.382941 0.512646 +214 1 4 0 -4.057362 7.911400 0.860642 +215 1 4 0 -3.677285 5.838816 -0.381317 +216 1 4 0 -5.097879 6.136516 -1.456773 +217 1 4 0 -6.958332 8.061232 -0.486042 +218 1 4 0 -6.120750 9.492014 0.254246 +219 1 4 0 -6.463653 8.052122 1.235972 +220 1 4 0 -6.708420 5.577546 0.309314 +221 1 4 0 -5.353714 5.729677 1.560568 +222 1 4 0 -5.449967 4.323238 0.397743 +223 1 1 0 -1.597496 9.147378 -0.364603 +224 1 2 0 -0.135695 9.298656 -0.268971 +225 1 2 0 0.407838 8.259131 0.762984 +226 1 3 0 -0.125678 8.256398 1.864934 +227 1 4 0 -2.061490 9.698188 0.341812 +228 1 4 0 0.291486 9.062300 -1.222284 +229 1 2 0 0.359683 10.712136 0.203065 +230 1 3 0 -0.513535 11.802509 -0.157986 +231 1 2 0 1.661404 11.100111 -0.496546 +232 1 4 0 0.487415 10.613723 1.289529 +233 1 4 0 -0.894682 12.193680 0.613553 +234 1 4 0 1.924560 12.095482 -0.170163 +235 1 4 0 1.527624 11.126022 -1.612055 +236 1 4 0 2.524096 10.406872 -0.273554 +237 1 1 0 1.458638 7.533911 0.367476 +238 1 2 0 2.250809 6.653110 1.155065 +239 1 2 0 3.767103 6.967571 0.917085 +240 1 3 0 4.150469 7.414883 -0.134304 +241 1 4 0 1.800100 7.626011 -0.603649 +242 1 4 0 1.984132 6.848652 2.199761 +243 1 2 0 1.985932 5.208560 0.673411 +244 1 2 0 0.499001 4.775460 0.950638 +245 1 2 0 0.302449 3.382258 0.307039 +246 1 2 0 0.318833 4.590905 2.467625 +247 1 4 0 2.620352 4.479840 1.153057 +248 1 4 0 2.170192 5.140748 -0.421262 +249 1 4 0 -0.141837 5.460611 0.448133 +250 1 4 0 -0.765868 3.158508 0.337643 +251 1 4 0 0.881511 2.586559 0.876485 +252 1 4 0 0.635114 3.382961 -0.727832 +253 1 4 0 0.991181 3.809378 2.860913 +254 1 4 0 -0.810422 4.305406 2.724253 +255 1 4 0 0.495432 5.527245 3.085307 +256 1 1 0 4.493868 6.668739 2.051013 +257 1 2 0 5.977452 6.826187 2.081574 +258 1 2 0 6.574479 5.473810 2.542943 +259 1 3 0 7.539223 5.437653 3.331859 +260 1 4 0 4.101906 6.335458 2.916399 +261 1 4 0 6.354091 6.853748 1.027532 +262 1 2 0 6.470006 8.005228 2.962480 +263 1 2 0 6.523156 9.385148 2.265263 +264 1 2 0 6.660389 10.531119 3.176475 +265 1 3 0 7.818717 10.946737 3.494784 +266 1 3 0 5.641727 11.057335 3.676704 +267 1 4 0 7.426538 7.872313 3.417016 +268 1 4 0 5.818378 7.862045 3.841666 +269 1 4 0 5.562369 9.490953 1.596644 +270 1 4 0 7.296811 9.382149 1.478494 +271 1 1 0 6.080956 4.317668 2.172588 +272 1 2 0 6.395184 2.914756 2.360428 +273 1 2 0 7.756330 2.626277 1.796235 +274 1 3 0 8.336336 3.369371 0.946953 +275 1 4 0 5.286582 4.431259 1.580017 +276 1 4 0 6.544551 2.775770 3.450173 +277 1 2 0 5.254270 2.029334 1.828047 +278 1 2 0 3.855516 2.115298 2.663831 +279 1 2 0 4.878513 2.275077 0.297641 +280 1 4 0 5.659978 0.937168 1.997214 +281 1 4 0 3.988977 1.632132 3.721066 +282 1 4 0 3.154094 1.488836 2.202125 +283 1 4 0 3.518024 3.208135 2.707458 +284 1 4 0 4.391723 3.244259 0.119355 +285 1 4 0 4.197460 1.515591 -0.214541 +286 1 4 0 5.820024 2.281294 -0.232189 +287 1 1 0 8.439412 1.532076 2.306730 +288 1 2 0 9.766718 1.104522 1.810124 +289 1 2 0 9.609640 -0.146333 0.921245 +290 1 3 0 8.595667 -0.823014 1.060066 +291 1 4 0 7.906057 0.817610 2.769235 +292 1 4 0 10.402589 1.878772 1.340853 +293 1 2 0 10.623245 0.647963 3.024596 +294 1 2 0 11.099332 1.681203 4.040791 +295 1 2 0 12.471923 2.276164 3.591284 +296 1 3 0 13.467460 1.635754 4.022756 +297 1 3 0 12.447093 3.241865 2.732975 +298 1 4 0 11.464087 0.045385 2.632771 +299 1 4 0 10.035308 -0.165388 3.606999 +300 1 4 0 11.283249 1.117646 5.042705 +301 1 4 0 10.341030 2.493195 4.310498 +302 1 1 0 10.649425 -0.442448 0.039711 +303 1 2 0 10.721650 -1.691625 -0.719097 +304 1 2 0 10.688929 -3.019270 0.171469 +305 1 3 0 10.136780 -4.017164 -0.258017 +306 1 4 0 9.824725 -1.703322 -1.331408 +307 1 2 0 12.047830 -1.730137 -1.583772 +308 1 2 0 12.438841 -0.254934 -1.430560 +309 1 2 0 11.880473 0.342410 -0.130781 +310 1 4 0 11.910217 -2.011767 -2.680814 +311 1 4 0 12.740874 -2.453727 -1.101295 +312 1 4 0 12.084519 0.391154 -2.320456 +313 1 4 0 13.550172 -0.165266 -1.345695 +314 1 4 0 11.730541 1.403440 -0.268593 +315 1 4 0 12.568702 0.262680 0.684216 +316 1 1 0 11.185418 -2.821488 1.401909 +317 1 2 0 11.478487 -3.819995 2.417066 +318 1 2 0 10.240507 -4.133695 3.340195 +319 1 3 0 10.437807 -4.944657 4.272068 +320 1 4 0 11.675553 -1.939666 1.629182 +321 1 4 0 11.715305 -4.763029 1.892686 +322 1 2 0 12.726302 -3.441835 3.258589 +323 1 3 0 12.588509 -2.169159 3.871288 +324 1 4 0 13.594515 -3.465914 2.619460 +325 1 4 0 12.919669 -4.225010 4.041833 +326 1 4 0 11.928461 -2.056942 4.572136 +327 1 1 0 8.989610 -3.538327 3.147788 +328 1 2 0 7.780090 -3.809839 3.903153 +329 1 2 0 6.830692 -4.723128 3.182411 +330 1 3 0 6.843975 -4.931536 1.971249 +331 1 4 0 8.790490 -2.959432 2.207143 +332 1 4 0 8.112743 -4.402734 4.754275 +333 1 2 0 7.007696 -2.493713 4.325713 +334 1 2 0 7.757815 -1.793205 5.421557 +335 1 3 0 8.301432 -0.683792 5.213313 +336 1 3 0 8.105449 -2.430264 6.467845 +337 1 4 0 6.015719 -2.736995 4.787540 +338 1 4 0 6.870322 -1.705199 3.554568 +339 1 1 0 5.911537 -5.420074 3.889645 +340 1 2 0 4.985368 -6.339027 3.207488 +341 1 2 0 3.791981 -5.460118 2.675447 +342 1 3 0 3.602436 -4.262217 3.058351 +343 1 4 0 5.945002 -5.355465 4.936544 +344 1 4 0 5.522096 -6.871961 2.401608 +345 1 2 0 4.403843 -7.437211 4.151447 +346 1 3 0 3.984983 -6.837474 5.417872 +347 1 2 0 5.484751 -8.435266 4.460478 +348 1 4 0 3.543374 -7.871125 3.610585 +349 1 4 0 3.626750 -7.635311 5.866975 +350 1 4 0 5.852794 -8.923165 3.576288 +351 1 4 0 5.092476 -9.235700 5.230406 +352 1 4 0 6.347457 -8.009387 5.033245 +353 1 1 0 3.001520 -6.091562 1.873663 +354 1 2 0 1.770212 -5.563203 1.356920 +355 1 2 0 0.721356 -5.331197 2.570590 +356 1 3 0 -0.022158 -4.354859 2.639919 +357 1 4 0 3.312873 -6.951353 1.400664 +358 1 4 0 2.050592 -4.577254 0.922928 +359 1 2 0 1.071972 -6.339450 0.158527 +360 1 2 0 1.737761 -5.960287 -1.242592 +361 1 2 0 -0.457848 -6.189077 0.133627 +362 1 2 0 3.239275 -5.961276 -1.280042 +363 1 4 0 1.324741 -7.458613 0.269568 +364 1 4 0 1.479259 -4.859796 -1.271486 +365 1 4 0 1.361220 -6.531125 -2.132946 +366 1 4 0 -0.903041 -6.854230 -0.657366 +367 1 4 0 -0.782418 -5.132849 -0.071473 +368 1 4 0 -0.922422 -6.573767 1.109124 +369 1 4 0 3.570026 -6.965706 -1.066579 +370 1 4 0 3.783014 -5.330759 -0.595789 +371 1 4 0 3.656696 -5.782972 -2.272787 +372 1 1 0 0.712989 -6.304521 3.584311 +373 1 2 0 0.052790 -6.261661 4.839148 +374 1 2 0 0.191347 -4.895606 5.488007 +375 1 3 0 -0.836031 -4.209177 5.761481 +376 1 4 0 1.234822 -7.176952 3.358561 +377 1 4 0 -1.022887 -6.329021 4.691721 +378 1 2 0 0.463881 -7.420468 5.813551 +379 1 2 0 -0.181732 -7.570702 7.165576 +380 1 2 0 0.007120 -6.414258 8.102713 +381 1 3 0 -0.893307 -5.557057 8.345423 +382 1 3 0 1.071916 -6.451342 8.739901 +383 1 4 0 1.565739 -7.379644 5.945185 +384 1 4 0 0.280894 -8.335875 5.233490 +385 1 4 0 0.223173 -8.515314 7.648734 +386 1 4 0 -1.278836 -7.754581 6.974807 +387 1 1 0 1.506487 -4.494779 5.655260 +388 1 2 0 2.024384 -3.272083 6.150972 +389 1 2 0 1.585880 -2.044887 5.407014 +390 1 3 0 1.072089 -1.054656 5.937784 +391 1 4 0 2.247022 -5.169015 5.381363 +392 1 4 0 1.726295 -3.077017 7.202284 +393 1 2 0 3.519486 -3.297907 6.249706 +394 1 2 0 4.110165 -2.209620 7.106417 +395 1 3 0 4.558866 -1.206675 6.574355 +396 1 1 0 3.975447 -2.353795 8.429417 +397 1 4 0 3.926527 -3.312701 5.199577 +398 1 4 0 3.906987 -4.290859 6.729019 +399 1 4 0 3.351621 -3.100412 8.835262 +400 1 4 0 4.250233 -1.572327 9.095945 +401 1 1 0 1.646215 -2.106555 3.995169 +402 1 2 0 0.960547 -1.056203 3.144271 +403 1 2 0 -0.585323 -0.906494 3.471384 +404 1 3 0 -1.001272 0.221409 3.639638 +405 1 4 0 2.076586 -2.917444 3.633085 +406 1 4 0 1.398083 -0.037330 3.348893 +407 1 2 0 1.148406 -1.421290 1.565953 +408 1 2 0 0.469253 -0.291141 0.677094 +409 1 2 0 2.652804 -1.432319 1.256255 +410 1 4 0 0.776571 -2.470203 1.403081 +411 1 4 0 -0.604778 -0.059927 0.825468 +412 1 4 0 0.696071 -0.403531 -0.364402 +413 1 4 0 0.904174 0.691668 0.985463 +414 1 4 0 2.642691 -1.597766 0.131660 +415 1 4 0 3.137894 -2.381059 1.586216 +416 1 4 0 3.298051 -0.632131 1.598249 +417 1 1 0 -1.305966 -1.988607 3.652565 +418 1 2 0 -2.689415 -1.960736 4.065894 +419 1 2 0 -2.947986 -1.384388 5.464246 +420 1 3 0 -3.956927 -0.687209 5.701440 +421 1 4 0 -0.971106 -2.849328 3.302467 +422 1 4 0 -3.296900 -1.262385 3.382761 +423 1 2 0 -3.427836 -3.412377 3.961933 +424 1 2 0 -3.574171 -3.928612 2.505721 +425 1 2 0 -3.982306 -5.479470 2.370643 +426 1 2 0 -4.137753 -5.916145 0.907307 +427 1 1 0 -4.842456 -7.207476 0.671588 +428 1 4 0 -4.389394 -3.425752 4.550163 +429 1 4 0 -2.806920 -4.163717 4.552623 +430 1 4 0 -2.578225 -3.744348 2.022778 +431 1 4 0 -4.131610 -3.317335 1.794895 +432 1 4 0 -4.944670 -5.685367 2.884988 +433 1 4 0 -3.219699 -6.072549 2.922384 +434 1 4 0 -3.220948 -5.866340 0.240386 +435 1 4 0 -4.886137 -5.224022 0.371600 +436 1 4 0 -4.398637 -8.010724 1.108282 +437 1 4 0 -4.689919 -7.536305 -0.283243 +438 1 4 0 -5.789366 -7.298894 0.961468 +439 1 1 0 -1.966539 -1.653932 6.352370 +440 1 2 0 -1.877059 -1.184384 7.700740 +441 1 2 0 -1.810243 0.352689 7.772527 +442 1 3 0 -2.478130 1.012858 8.630055 +443 1 4 0 -1.296883 -2.342673 6.065841 +444 1 4 0 -2.903503 -1.425619 8.306499 +445 1 2 0 -0.719870 -1.906634 8.460693 +446 1 4 0 -0.392867 -1.394748 9.399750 +447 1 4 0 0.201561 -1.700787 7.931161 +448 1 4 0 -0.824494 -3.016135 8.415257 +449 1 1 0 -1.014819 0.884949 6.873831 +450 1 2 0 -0.928004 2.359933 6.752150 +451 1 2 0 -2.242871 3.020975 6.141860 +452 1 3 0 -2.667293 4.165871 6.497798 +453 1 4 0 -0.255487 0.266534 6.475305 +454 1 4 0 -0.709751 2.767594 7.790539 +455 1 2 0 0.185451 2.818592 5.731872 +456 1 2 0 1.718082 2.368933 6.157097 +457 1 2 0 1.976397 2.630036 7.634372 +458 1 2 0 3.272626 1.811866 8.042755 +459 1 1 0 3.783277 2.119562 9.341763 +460 1 4 0 0.173809 4.017727 5.824418 +461 1 4 0 -0.110843 2.644975 4.655738 +462 1 4 0 2.436177 2.906087 5.459782 +463 1 4 0 1.767963 1.228903 6.013437 +464 1 4 0 1.214734 2.413689 8.372810 +465 1 4 0 2.023085 3.725792 7.759055 +466 1 4 0 4.113891 1.884123 7.336520 +467 1 4 0 2.915132 0.727469 8.065927 +468 1 4 0 3.879659 1.332383 9.938486 +469 1 4 0 3.292027 2.768104 9.893226 +470 1 4 0 4.657654 2.620898 9.415395 +471 1 1 0 -2.951323 2.325118 5.282730 +472 1 2 0 -4.325905 2.722744 4.841568 +473 1 2 0 -5.448579 2.576087 5.910067 +474 1 3 0 -6.209518 3.521045 6.095847 +475 1 4 0 -2.521898 1.551084 4.791650 +476 1 4 0 -4.313051 3.829830 4.708638 +477 1 2 0 -4.631289 2.056947 3.491556 +478 1 2 0 -3.597982 2.356462 2.341899 +479 1 2 0 -6.057287 2.415036 2.978562 +480 1 2 0 -3.795503 1.412901 1.156511 +481 1 4 0 -4.671054 0.937191 3.752299 +482 1 4 0 -2.607674 2.121882 2.680974 +483 1 4 0 -3.588639 3.467984 2.067654 +484 1 4 0 -6.778277 2.127584 3.784506 +485 1 4 0 -6.408690 1.672558 2.286363 +486 1 4 0 -6.257305 3.445522 2.543283 +487 1 4 0 -2.827681 1.370598 0.452926 +488 1 4 0 -4.701905 1.709692 0.600596 +489 1 4 0 -3.968868 0.353877 1.535108 +490 1 1 0 -5.427736 1.517434 6.772139 +491 1 2 0 -6.281638 1.417159 7.917235 +492 1 2 0 -6.135061 2.619316 8.825463 +493 1 3 0 -7.083993 3.050483 9.468967 +494 1 4 0 -4.778187 0.710522 6.592937 +495 1 4 0 -7.347518 1.392997 7.523591 +496 1 2 0 -5.911289 0.089334 8.730160 +497 1 2 0 -6.704804 -0.165892 10.024245 +498 1 2 0 -8.207420 0.060746 9.966819 +499 1 3 0 -8.766731 0.511631 10.987813 +500 1 1 0 -8.851167 -0.577098 8.977765 +501 1 4 0 -4.871800 0.035639 8.932959 +502 1 4 0 -6.099650 -0.797867 8.002499 +503 1 4 0 -6.379603 0.602172 10.795373 +504 1 4 0 -6.514059 -1.228415 10.339368 +505 1 4 0 -8.316985 -1.014678 8.258816 +506 1 4 0 -9.833090 -0.545963 8.919578 +507 1 1 0 -4.878643 3.139322 9.062914 +508 1 2 0 -4.649566 4.328949 9.987955 +509 1 2 0 -4.957775 5.668926 9.413617 +510 1 3 0 -5.630236 6.445624 10.106188 +511 1 4 0 -4.081549 2.846329 8.507102 +512 1 4 0 -5.406537 4.281488 10.784832 +513 1 2 0 -3.243945 4.227889 10.546816 +514 1 2 0 -3.087728 5.171882 11.728346 +515 1 3 0 -4.053576 5.190045 12.600221 +516 1 3 0 -2.058101 5.835943 11.978474 +517 1 4 0 -2.562382 4.521403 9.724738 +518 1 4 0 -2.932032 3.215635 10.964683 +519 1 1 0 -4.878039 5.785317 8.031390 +520 1 2 0 -5.310084 7.089332 7.406389 +521 1 2 0 -6.749125 7.172087 6.971101 +522 1 3 0 -7.405628 8.229614 7.089684 +523 1 4 0 -4.283642 5.091117 7.531729 +524 1 4 0 -5.274077 7.841191 8.198368 +525 1 2 0 -4.287673 7.649544 6.440392 +526 1 2 0 -4.264316 6.824230 5.084233 +527 1 2 0 -3.348184 7.282872 3.940214 +528 1 2 0 -1.862959 6.984827 4.246876 +529 1 1 0 -1.232990 7.951755 5.175746 +530 1 4 0 -3.353989 7.682751 6.978380 +531 1 4 0 -4.577117 8.665353 6.188031 +532 1 4 0 -5.271336 7.010431 4.645228 +533 1 4 0 -4.183939 5.756196 5.214904 +534 1 4 0 -3.478219 8.414723 3.726542 +535 1 4 0 -3.567163 6.665420 3.125679 +536 1 4 0 -1.380469 7.033451 3.200397 +537 1 4 0 -1.658625 5.960828 4.579387 +538 1 4 0 -1.681026 8.865239 5.169898 +539 1 4 0 -0.322832 8.170574 4.811931 +540 1 4 0 -1.120976 7.690090 6.115363 +541 1 1 0 -7.260673 6.129896 6.365283 +542 1 2 0 -8.574938 6.119982 5.731267 +543 1 2 0 -9.544300 5.242356 6.500946 +544 1 3 0 -10.776630 5.341657 6.228564 +545 1 4 0 -6.694313 5.297054 6.084394 +546 1 4 0 -8.965369 7.148290 5.836761 +547 1 2 0 -8.593435 5.700600 4.232465 +548 1 2 0 -8.142917 6.797216 3.313691 +549 1 2 0 -8.922098 8.128550 3.290754 +550 1 3 0 -10.019708 8.282415 2.683597 +551 1 3 0 -8.418377 9.080422 3.962396 +552 1 4 0 -9.637470 5.370747 3.983240 +553 1 4 0 -7.841735 4.791994 4.106244 +554 1 4 0 -7.988334 6.410373 2.240226 +555 1 4 0 -7.108545 7.056748 3.606925 +556 1 1 0 -9.109752 4.287946 7.340476 +557 1 2 0 -10.009860 3.416611 8.055823 +558 1 2 0 -10.705939 2.327979 7.248022 +559 1 3 0 -11.556202 1.623209 7.719085 +560 1 4 0 -8.134437 4.133993 7.462110 +561 1 4 0 -9.403268 2.909131 8.828371 +562 1 4 0 -10.766691 4.008828 8.630570 +563 1 1 0 -10.238426 2.084832 5.988242 +564 1 2 0 -10.830327 1.014314 5.135787 +565 1 2 0 -10.123635 -0.408365 5.490888 +566 1 3 0 -8.886974 -0.473105 5.573450 +567 1 4 0 -9.463779 2.473999 5.471519 +568 1 4 0 -11.972825 0.862184 5.405029 +569 1 2 0 -10.573783 1.408499 3.605155 +570 1 2 0 -11.473874 2.659840 3.274246 +571 1 2 0 -10.768674 0.116838 2.675834 +572 1 2 0 -11.386046 3.100490 1.827956 +573 1 4 0 -9.497664 1.719665 3.575726 +574 1 4 0 -11.189235 3.505368 3.971634 +575 1 4 0 -12.466031 2.387035 3.608591 +576 1 4 0 -10.418619 0.285197 1.650312 +577 1 4 0 -11.889425 -0.154704 2.658339 +578 1 4 0 -10.253412 -0.844191 2.935472 +579 1 4 0 -10.489631 3.687189 1.608836 +580 1 4 0 -12.252949 3.808896 1.730836 +581 1 4 0 -11.600834 2.256313 1.164934 +582 1 1 0 -10.904182 -1.495291 5.769914 +583 1 2 0 -10.294825 -2.685192 6.266115 +584 1 2 0 -9.362686 -3.411747 5.150144 +585 1 3 0 -9.822907 -3.806655 4.048145 +586 1 4 0 -9.678597 -2.483780 7.200705 +587 1 2 0 -11.433893 -3.623279 6.740457 +588 1 2 0 -12.623002 -3.096904 5.800687 +589 1 2 0 -12.355474 -1.596314 5.926055 +590 1 4 0 -11.632975 -3.481644 7.836795 +591 1 4 0 -11.185183 -4.717775 6.760900 +592 1 4 0 -13.676441 -3.284634 6.130235 +593 1 4 0 -12.571296 -3.294434 4.749284 +594 1 4 0 -12.712668 -1.093954 6.983468 +595 1 4 0 -12.878080 -1.082331 5.087665 +596 1 1 0 -8.141305 -3.913338 5.553940 +597 1 2 0 -7.265296 -4.892156 4.877616 +598 1 2 0 -7.954629 -6.074235 4.106746 +599 1 3 0 -7.526189 -6.449816 3.017058 +600 1 4 0 -6.579043 -4.462262 4.120819 +601 1 2 0 -6.340090 -5.386881 5.987491 +602 1 2 0 -6.098980 -4.115508 6.793069 +603 1 2 0 -7.478029 -3.499220 6.819358 +604 1 4 0 -5.439953 -5.907262 5.648183 +605 1 4 0 -6.857707 -6.166813 6.603499 +606 1 4 0 -5.359728 -3.456071 6.338156 +607 1 4 0 -5.774381 -4.378426 7.875984 +608 1 4 0 -7.367742 -2.409829 6.921891 +609 1 4 0 -8.055072 -3.868224 7.656931 +610 1 1 0 -9.008919 -6.608446 4.793434 +611 1 2 0 -9.678181 -7.733135 4.285369 +612 1 2 0 -10.514900 -7.453854 3.062726 +613 1 3 0 -10.598980 -8.267352 2.099054 +614 1 4 0 -9.372380 -6.226786 5.718134 +615 1 4 0 -8.952673 -8.430078 3.800831 +616 1 2 0 -10.385978 -8.504460 5.406790 +617 1 2 0 -11.095963 -9.718862 4.959627 +618 1 3 0 -12.323382 -9.860403 5.304109 +619 1 3 0 -10.342738 -10.617376 4.418998 +620 1 4 0 -11.151852 -7.927877 5.826167 +621 1 4 0 -9.623560 -8.740853 6.193107 +622 1 1 0 -11.049078 -6.202245 2.940419 +623 1 2 0 -11.642018 -5.709443 1.705877 +624 1 2 0 -10.614336 -5.092838 0.713167 +625 1 3 0 -10.927213 -4.951138 -0.459225 +626 1 4 0 -11.081256 -5.587042 3.696816 +627 1 4 0 -11.984075 -6.605539 1.087897 +628 1 2 0 -12.768231 -4.705104 1.983069 +629 1 2 0 -13.883829 -5.316250 2.907105 +630 1 2 0 -15.114338 -4.418666 2.924881 +631 1 3 0 -15.405304 -3.917271 4.026449 +632 1 1 0 -15.906827 -4.358107 1.868346 +633 1 4 0 -13.285557 -4.431812 1.024843 +634 1 4 0 -12.425058 -3.757312 2.498081 +635 1 4 0 -13.493993 -5.422715 3.976146 +636 1 4 0 -14.172955 -6.317959 2.590855 +637 1 4 0 -15.643280 -4.761085 0.943045 +638 1 4 0 -16.887617 -4.110344 2.002905 +639 1 1 0 -9.403516 -4.718671 1.187009 +640 1 2 0 -8.418526 -4.190723 0.263736 +641 1 2 0 -7.842430 -5.239112 -0.660532 +642 1 3 0 -7.328931 -6.262671 -0.141830 +643 1 4 0 -9.039521 -4.862514 2.100989 +644 1 4 0 -8.913388 -3.436668 -0.331077 +645 1 2 0 -7.143827 -3.503558 1.041637 +646 1 2 0 -7.586437 -2.244888 1.828880 +647 1 2 0 -6.397386 -1.503568 2.513414 +648 1 3 0 -5.279630 -1.340947 1.984414 +649 1 1 0 -6.649301 -1.020214 3.747788 +650 1 4 0 -6.392988 -3.161834 0.246377 +651 1 4 0 -6.600747 -4.159050 1.729753 +652 1 4 0 -8.388106 -2.412938 2.663083 +653 1 4 0 -8.063908 -1.554062 1.129126 +654 1 4 0 -7.599327 -0.974932 4.121687 +655 1 4 0 -5.824088 -0.762663 4.379842 +656 1 1 0 -7.975739 -5.085940 -2.051099 +657 1 2 0 -7.316226 -5.859411 -3.099220 +658 1 2 0 -6.535954 -4.884159 -3.940503 +659 1 3 0 -7.016650 -4.323287 -4.885061 +660 1 4 0 -8.649330 -4.421740 -2.442279 +661 1 4 0 -6.552638 -6.577875 -2.549459 +662 1 2 0 -8.293193 -6.657174 -4.000956 +663 1 2 0 -8.951016 -7.920548 -3.205693 +664 1 2 0 -8.120004 -9.231611 -2.981077 +665 1 1 0 -7.224446 -9.317181 -1.844858 +666 1 2 0 -6.456272 -10.352566 -1.540149 +667 1 1 0 -6.261777 -11.358001 -2.422146 +668 1 1 0 -6.102837 -10.524228 -0.288739 +669 1 4 0 -7.757336 -7.047341 -4.904160 +670 1 4 0 -9.163272 -5.963583 -4.290787 +671 1 4 0 -9.924984 -8.240285 -3.732011 +672 1 4 0 -9.185465 -7.539611 -2.167170 +673 1 4 0 -7.474087 -9.426829 -3.909433 +674 1 4 0 -8.804222 -10.092199 -2.813314 +675 1 4 0 -7.241497 -8.530605 -1.089185 +676 1 4 0 -6.629122 -11.380337 -3.383889 +677 1 4 0 -5.815388 -12.216685 -2.108949 +678 1 4 0 -6.430516 -9.899279 0.447997 +679 1 4 0 -5.622476 -11.346782 -0.024111 +680 1 1 0 -5.292942 -4.653337 -3.548836 +681 1 2 0 -4.364875 -3.733621 -4.272520 +682 1 2 0 -3.884056 -4.434009 -5.580010 +683 1 3 0 -3.533279 -5.624908 -5.562725 +684 1 4 0 -4.823372 -5.284331 -2.925755 +685 1 4 0 -4.946353 -2.808529 -4.509708 +686 1 2 0 -3.111739 -3.306714 -3.368632 +687 1 2 0 -3.512923 -2.415189 -2.103271 +688 1 2 0 -2.187524 -2.216424 -1.223893 +689 1 2 0 -3.958754 -1.022674 -2.555738 +690 1 4 0 -2.365328 -2.709721 -3.991308 +691 1 4 0 -2.556390 -4.179643 -2.968211 +692 1 4 0 -4.305604 -2.923554 -1.464240 +693 1 4 0 -2.062550 -3.144793 -0.620117 +694 1 4 0 -2.115031 -1.291482 -0.497561 +695 1 4 0 -1.342308 -2.211899 -1.862143 +696 1 4 0 -3.107951 -0.478453 -3.033604 +697 1 4 0 -4.161562 -0.403495 -1.628661 +698 1 4 0 -4.885892 -1.120725 -3.194404 +699 1 1 0 -3.856496 -3.700788 -6.722801 +700 1 2 0 -3.452842 -4.182763 -8.089520 +701 1 2 0 -2.174020 -3.372729 -8.520048 +702 1 3 0 -2.088562 -2.114569 -8.327579 +703 1 4 0 -3.898301 -2.618583 -6.734908 +704 1 4 0 -3.183017 -5.236597 -7.998616 +705 1 2 0 -4.717190 -3.967990 -8.947270 +706 1 2 0 -5.895436 -4.854833 -8.519342 +707 1 2 0 -4.331848 -4.232926 -10.428080 +708 1 2 0 -5.797633 -6.318004 -8.660393 +709 1 4 0 -4.967766 -2.891891 -8.863808 +710 1 4 0 -6.807800 -4.540991 -9.113471 +711 1 4 0 -6.224024 -4.682991 -7.474756 +712 1 4 0 -5.263890 -4.453041 -11.073519 +713 1 4 0 -3.637199 -5.120375 -10.524428 +714 1 4 0 -3.762608 -3.358380 -10.861528 +715 1 4 0 -4.807288 -6.678730 -8.216144 +716 1 4 0 -5.855482 -6.587729 -9.747066 +717 1 4 0 -6.665159 -6.845883 -8.176671 +718 1 1 0 -1.222564 -4.057751 -9.205087 +719 1 2 0 -0.136624 -3.415950 -9.921138 +720 1 2 0 0.070256 -3.976880 -11.394080 +721 1 3 0 0.610536 -5.076439 -11.582664 +722 1 4 0 -1.285072 -5.056820 -9.232195 +723 1 4 0 -0.492377 -2.326993 -10.196345 +724 1 2 0 1.325233 -3.451838 -9.292553 +725 1 2 0 2.252979 -2.485580 -9.980048 +726 1 2 0 1.821424 -1.150642 -9.963953 +727 1 2 0 3.553048 -2.772749 -10.524243 +728 1 2 0 2.627188 -0.136222 -10.473998 +729 1 2 0 4.271695 -1.747890 -11.019280 +730 1 2 0 3.875296 -0.391840 -11.048201 +731 1 4 0 1.721374 -4.514315 -9.302918 +732 1 4 0 1.363608 -3.152679 -8.161531 +733 1 4 0 0.900203 -0.869990 -9.442890 +734 1 4 0 4.058655 -3.780788 -10.525233 +735 1 4 0 2.406689 0.963664 -10.402987 +736 1 4 0 5.227337 -2.093738 -11.483853 +737 1 4 0 4.613135 0.382875 -11.414402 +738 1 1 0 -0.469213 -3.209862 -12.373989 +739 1 2 0 -0.546701 -3.542255 -13.816781 +740 1 2 0 -1.166423 -4.938647 -14.104553 +741 1 3 0 -0.706356 -5.741630 -14.896149 +742 1 4 0 -0.983659 -2.328002 -12.034153 +743 1 4 0 -1.328286 -2.810564 -14.197792 +744 1 2 0 0.847710 -3.453814 -14.522754 +745 1 4 0 1.557524 -2.617362 -14.253614 +746 1 4 0 0.737328 -3.373371 -15.641978 +747 1 4 0 1.440476 -4.334496 -14.238884 +748 1 1 0 -2.318816 -5.128826 -13.446057 +749 1 2 0 -3.143886 -6.311856 -13.378529 +750 1 2 0 -2.861305 -7.249269 -12.148953 +751 1 3 0 -3.693124 -8.018797 -11.770725 +752 1 4 0 -2.759876 -4.364139 -12.830293 +753 1 4 0 -4.238045 -6.105454 -13.271863 +754 1 4 0 -3.058170 -6.943948 -14.307195 +755 1 1 0 -1.585886 -7.303614 -11.606121 +756 1 2 0 -1.141926 -8.330961 -10.575659 +757 1 2 0 -1.714720 -8.146916 -9.185538 +758 1 3 0 -1.663641 -7.016934 -8.671236 +759 1 4 0 -0.991604 -6.486688 -11.627949 +760 1 4 0 -1.432507 -9.342075 -10.930403 +761 1 2 0 0.441949 -8.242663 -10.513047 +762 1 2 0 1.115895 -8.804397 -11.798957 +763 1 2 0 2.659392 -8.559556 -11.862927 +764 1 2 0 3.525297 -9.477008 -11.044076 +765 1 1 0 4.928913 -9.126450 -11.049928 +766 1 4 0 0.930008 -8.793558 -9.704840 +767 1 4 0 0.820281 -7.154573 -10.383627 +768 1 4 0 0.726808 -8.346899 -12.740661 +769 1 4 0 0.816642 -9.905594 -11.898832 +770 1 4 0 2.766554 -7.492314 -11.630235 +771 1 4 0 2.990272 -8.709413 -12.938787 +772 1 4 0 3.480243 -10.547229 -11.281436 +773 1 4 0 3.142144 -9.394311 -9.993141 +774 1 4 0 5.380243 -9.145878 -11.941964 +775 1 4 0 5.445854 -9.749951 -10.436478 +776 1 4 0 5.117208 -8.202842 -10.744769 +777 1 1 0 -2.261410 -9.249088 -8.588259 +778 1 2 0 -2.615396 -9.233499 -7.225533 +779 1 2 0 -1.335567 -8.948793 -6.438233 +780 1 3 0 -0.279868 -9.480653 -6.690356 +781 1 4 0 -2.255352 -10.169786 -9.074177 +782 1 4 0 -3.334713 -8.420685 -7.023961 +783 1 2 0 -3.251131 -10.563774 -6.767452 +784 1 2 0 -4.535149 -10.474262 -6.008036 +785 1 2 0 -4.398618 -9.939824 -4.513090 +786 1 3 0 -5.077126 -8.969050 -4.171499 +787 1 1 0 -3.545204 -10.582628 -3.678241 +788 1 4 0 -2.536808 -11.208918 -6.196239 +789 1 4 0 -3.428126 -11.121298 -7.678818 +790 1 4 0 -4.970296 -11.490264 -5.897297 +791 1 4 0 -5.221487 -9.801148 -6.555491 +792 1 4 0 -3.257694 -11.568395 -3.807768 +793 1 4 0 -3.345020 -10.122941 -2.746863 +794 1 1 0 -1.450039 -8.014788 -5.496898 +795 1 2 0 -0.421843 -7.645217 -4.599782 +796 1 2 0 -0.664467 -8.314648 -3.266854 +797 1 3 0 -1.615751 -8.129338 -2.521866 +798 1 4 0 -2.373522 -7.541372 -5.361698 +799 1 4 0 0.525104 -7.914594 -5.012102 +800 1 2 0 -0.361457 -6.082978 -4.502645 +801 1 2 0 0.013954 -5.455430 -5.851982 +802 1 2 0 0.049019 -3.957376 -5.617040 +803 1 2 0 1.428022 -5.979157 -6.227374 +804 1 4 0 0.435555 -5.929917 -3.703749 +805 1 4 0 -1.370222 -5.613724 -4.112042 +806 1 4 0 -0.783872 -5.696630 -6.601592 +807 1 4 0 -0.918682 -3.670337 -5.057847 +808 1 4 0 -0.051016 -3.481788 -6.645675 +809 1 4 0 0.927863 -3.578685 -5.148034 +810 1 4 0 1.304895 -7.011135 -6.510945 +811 1 4 0 2.256941 -6.075607 -5.425529 +812 1 4 0 1.836340 -5.473788 -7.076509 +813 1 1 0 0.008587 -9.534155 -3.176981 +814 1 2 0 -0.164006 -10.610017 -2.276861 +815 1 2 0 0.455793 -10.123372 -0.937523 +816 1 3 0 1.609433 -9.732719 -0.855349 +817 1 4 0 0.661532 -9.822276 -3.993714 +818 1 4 0 -1.244755 -10.767542 -2.035039 +819 1 2 0 0.574437 -11.905679 -2.866050 +820 1 2 0 0.334302 -13.196441 -2.052243 +821 1 2 0 0.695999 -13.209957 -0.547494 +822 1 3 0 -0.264686 -13.183024 0.298109 +823 1 3 0 1.910632 -13.459361 -0.183932 +824 1 4 0 1.710862 -11.775851 -2.827976 +825 1 4 0 0.358791 -11.917380 -3.993445 +826 1 4 0 0.882365 -13.997962 -2.620937 +827 1 4 0 -0.759904 -13.530227 -2.138213 +828 1 1 0 -0.357453 -10.118381 0.156881 +829 1 2 0 -0.126858 -9.579761 1.459753 +830 1 2 0 1.210865 -9.885856 2.201894 +831 1 3 0 1.578355 -9.098965 3.087348 +832 1 4 0 -1.314386 -10.278297 -0.048400 +833 1 4 0 -0.027285 -8.417312 1.375403 +834 1 2 0 -1.323443 -9.874534 2.428279 +835 1 2 0 -2.796658 -9.594191 2.040205 +836 1 3 0 -3.598938 -8.858694 2.747148 +837 1 3 0 -3.069275 -9.875155 0.835441 +838 1 4 0 -1.081085 -9.350501 3.331576 +839 1 4 0 -1.329114 -10.904878 2.757681 +840 1 1 0 1.774130 -11.086092 1.992881 +841 1 2 0 2.994120 -11.545091 2.708587 +842 1 2 0 4.377665 -11.351494 1.943197 +843 1 3 0 5.433148 -11.274449 2.624196 +844 1 4 0 1.231410 -11.794245 1.490134 +845 1 4 0 3.087086 -10.934376 3.717487 +846 1 4 0 2.994182 -12.632411 2.994368 +847 1 1 0 4.334836 -11.180015 0.643592 +848 1 2 0 5.298784 -10.617673 -0.256284 +849 1 2 0 5.545436 -9.161422 0.121481 +850 1 3 0 4.681756 -8.523001 0.675460 +851 1 4 0 3.389098 -11.194600 0.224796 +852 1 4 0 6.302556 -11.051188 -0.027697 +853 1 2 0 4.842303 -10.729803 -1.752153 +854 1 2 0 4.713323 -12.135756 -2.446341 +855 1 2 0 5.630639 -13.213151 -1.906582 +856 1 1 0 5.284941 -13.736409 -0.601898 +857 1 2 0 6.075566 -13.904284 0.492928 +858 1 1 0 7.378324 -13.682239 0.392183 +859 1 1 0 5.537046 -14.223213 1.666359 +860 1 4 0 5.533031 -10.123030 -2.400529 +861 1 4 0 3.921522 -10.207566 -1.834451 +862 1 4 0 4.892154 -12.013932 -3.582693 +863 1 4 0 3.646766 -12.426728 -2.380513 +864 1 4 0 6.696275 -12.970967 -1.977244 +865 1 4 0 5.489916 -14.113101 -2.629388 +866 1 4 0 4.272537 -13.863270 -0.494816 +867 1 4 0 7.985377 -13.700052 -0.424821 +868 1 4 0 7.940470 -13.667672 1.245648 +869 1 4 0 4.531855 -14.502228 1.787659 +870 1 4 0 6.101298 -14.389973 2.557369 +871 1 1 0 6.795959 -8.709417 -0.229618 +872 1 2 0 7.151484 -7.314826 -0.044504 +873 1 2 0 6.772152 -6.618863 -1.344791 +874 1 3 0 6.491580 -7.195037 -2.353138 +875 1 4 0 7.318576 -9.171415 -1.002843 +876 1 4 0 6.525833 -6.859535 0.829338 +877 1 2 0 8.635451 -7.121669 0.159249 +878 1 3 0 9.319110 -7.714935 -0.864105 +879 1 2 0 9.122393 -7.761915 1.542275 +880 1 4 0 8.861381 -6.006942 0.177513 +881 1 4 0 10.194312 -7.422946 -0.650194 +882 1 4 0 10.121810 -7.432113 1.729501 +883 1 4 0 9.135396 -8.869565 1.459149 +884 1 4 0 8.446951 -7.382073 2.362364 +885 1 1 0 6.963090 -5.264591 -1.254451 +886 1 2 0 6.942143 -4.382454 -2.396821 +887 1 2 0 8.032255 -4.727919 -3.355290 +888 1 3 0 7.874094 -4.700903 -4.606280 +889 1 4 0 7.090170 -4.902090 -0.328807 +890 1 4 0 6.016462 -4.502766 -2.986232 +891 1 2 0 7.011823 -2.893701 -1.884788 +892 1 2 0 5.619258 -2.371640 -1.146601 +893 1 2 0 5.747407 -0.832171 -0.836537 +894 1 2 0 4.304852 -2.632042 -1.932473 +895 1 4 0 7.232530 -2.302129 -2.742395 +896 1 4 0 7.918264 -2.789406 -1.123344 +897 1 4 0 5.453202 -2.916654 -0.186086 +898 1 4 0 4.887008 -0.456110 -0.323416 +899 1 4 0 5.896335 -0.152245 -1.791542 +900 1 4 0 6.670665 -0.673450 -0.254409 +901 1 4 0 4.181643 -2.082693 -2.916672 +902 1 4 0 3.442444 -2.383879 -1.330292 +903 1 4 0 4.282395 -3.716052 -2.117091 +904 1 1 0 9.237825 -5.055680 -2.844670 +905 1 2 0 10.327506 -5.326158 -3.751795 +906 1 2 0 10.299712 -6.687552 -4.448700 +907 1 3 0 11.020799 -6.802866 -5.444496 +908 1 4 0 9.513335 -4.765910 -1.839355 +909 1 4 0 10.385954 -4.560168 -4.527939 +910 1 2 0 11.616785 -5.225390 -2.849555 +911 1 3 0 11.681845 -6.184576 -1.811464 +912 1 4 0 11.731770 -4.245308 -2.404822 +913 1 4 0 12.479811 -5.484003 -3.480128 +914 1 4 0 12.247855 -6.858858 -2.142458 +915 1 1 0 9.390895 -7.583629 -4.036730 +916 1 2 0 8.992160 -8.754252 -4.825764 +917 1 2 0 8.441950 -8.325775 -6.179531 +918 1 3 0 8.453951 -9.076338 -7.106677 +919 1 4 0 8.901001 -7.489208 -3.091813 +920 1 4 0 10.003891 -9.220020 -5.018515 +921 1 2 0 8.053488 -9.759256 -4.183158 +922 1 2 0 8.636121 -10.682406 -3.119472 +923 1 3 0 8.285666 -10.472382 -1.922177 +924 1 3 0 9.461725 -11.579888 -3.491527 +925 1 4 0 7.570077 -10.438277 -4.930342 +926 1 4 0 7.245571 -9.201184 -3.714526 +927 1 1 0 7.768214 -7.119718 -6.199610 +928 1 2 0 7.005887 -6.638728 -7.315257 +929 1 2 0 7.851617 -5.582566 -8.113333 +930 1 3 0 7.595614 -5.232955 -9.268020 +931 1 4 0 7.640444 -6.594365 -5.349903 +932 1 4 0 6.951423 -7.445998 -8.104085 +933 1 2 0 5.604718 -6.020286 -6.971603 +934 1 2 0 4.808080 -7.258931 -6.484822 +935 1 2 0 4.589395 -7.461018 -5.120438 +936 1 2 0 4.447069 -8.273894 -7.429155 +937 1 2 0 3.784056 -8.535024 -4.755017 +938 1 2 0 3.579283 -9.310814 -7.055696 +939 1 2 0 3.326057 -9.397762 -5.690539 +940 1 3 0 2.439893 -10.287138 -5.195207 +941 1 4 0 5.141919 -5.567564 -7.921399 +942 1 4 0 5.606057 -5.151689 -6.311062 +943 1 4 0 4.944905 -6.731723 -4.350204 +944 1 4 0 4.660459 -8.167346 -8.489786 +945 1 4 0 3.457378 -8.750277 -3.665145 +946 1 4 0 3.267954 -10.081994 -7.761989 +947 1 4 0 2.186803 -10.747811 -5.996630 +948 1 1 0 8.902051 -5.011864 -7.407302 +949 1 2 0 9.703612 -3.896573 -7.971331 +950 1 2 0 8.854605 -2.738907 -8.339936 +951 1 3 0 9.065146 -2.145748 -9.384005 +952 1 4 0 9.116746 -5.266463 -6.458188 +953 1 4 0 10.386108 -3.586461 -7.092001 +954 1 2 0 10.578732 -4.353776 -9.179322 +955 1 2 0 11.689249 -3.400850 -9.487746 +956 1 3 0 11.683048 -2.729553 -10.505813 +957 1 1 0 12.685159 -3.379988 -8.534891 +958 1 4 0 9.859055 -4.483921 -10.059621 +959 1 4 0 11.053015 -5.363302 -8.978055 +960 1 4 0 12.816952 -4.073113 -7.744033 +961 1 4 0 13.500082 -2.669172 -8.653591 +962 1 1 0 7.961974 -2.346899 -7.450123 +963 1 2 0 7.210073 -1.082393 -7.353242 +964 1 2 0 8.220074 -0.014005 -6.989916 +965 1 3 0 8.976625 -0.122583 -6.038982 +966 1 4 0 7.839428 -2.859206 -6.569147 +967 1 4 0 6.707337 -0.850947 -8.383918 +968 1 2 0 6.030095 -1.285349 -6.242570 +969 1 2 0 4.899744 -1.930604 -7.085273 +970 1 2 0 5.645671 -0.002619 -5.492558 +971 1 2 0 3.850643 -2.639039 -6.295674 +972 1 4 0 6.419510 -1.908236 -5.417144 +973 1 4 0 5.364352 -2.708104 -7.784017 +974 1 4 0 4.483419 -1.167649 -7.800574 +975 1 4 0 5.004870 -0.066649 -4.602552 +976 1 4 0 5.129294 0.689353 -6.215366 +977 1 4 0 6.560668 0.460605 -5.074466 +978 1 4 0 3.234235 -1.930388 -5.649940 +979 1 4 0 4.384891 -3.374819 -5.577049 +980 1 4 0 3.162458 -3.233503 -6.928627 +981 1 1 0 8.279015 1.096767 -7.735473 +982 1 2 0 9.149500 2.177313 -7.448918 +983 1 2 0 8.443049 3.455173 -7.091881 +984 1 3 0 7.225838 3.588535 -7.314849 +985 1 4 0 7.643874 1.078344 -8.517521 +986 1 4 0 9.726155 1.989811 -6.530547 +987 1 2 0 10.141562 2.393897 -8.637297 +988 1 2 0 11.175363 1.278751 -8.856450 +989 1 2 0 12.297979 1.259017 -7.866598 +990 1 3 0 13.426383 1.600621 -8.288936 +991 1 1 0 12.128586 0.499484 -6.748544 +992 1 4 0 10.711669 3.336580 -8.503837 +993 1 4 0 9.628679 2.543322 -9.607849 +994 1 4 0 11.602578 1.390889 -9.880921 +995 1 4 0 10.646349 0.304077 -8.758295 +996 1 4 0 11.162328 0.324257 -6.474357 +997 1 4 0 12.859952 0.645961 -6.011600 +998 1 1 0 9.290608 4.442003 -6.647564 +999 1 2 0 8.811159 5.826111 -6.212163 +1000 1 2 0 7.909587 6.365352 -7.395189 +1001 1 3 0 8.277887 6.147537 -8.576688 +1002 1 4 0 10.326040 4.354253 -6.566650 +1003 1 4 0 8.074366 5.700259 -5.392561 +1004 1 2 0 9.995835 6.763127 -5.753453 +1005 1 2 0 11.134989 6.936166 -6.773871 +1006 1 2 0 12.450245 7.429690 -6.051861 +1007 1 2 0 12.385757 8.858415 -5.565813 +1008 1 1 0 13.633988 9.413177 -5.138817 +1009 1 4 0 10.292905 6.307034 -4.826845 +1010 1 4 0 9.733735 7.849575 -5.494064 +1011 1 4 0 10.808074 7.681538 -7.552779 +1012 1 4 0 11.297990 5.963599 -7.337475 +1013 1 4 0 13.159036 7.413697 -6.874982 +1014 1 4 0 12.808296 6.686485 -5.298299 +1015 1 4 0 11.641999 8.947159 -4.656213 +1016 1 4 0 11.959207 9.504307 -6.407475 +1017 1 4 0 13.653846 10.372301 -4.854541 +1018 1 4 0 14.288544 9.333898 -5.904378 +1019 1 4 0 14.092755 8.836443 -4.392426 +1020 1 1 0 6.734291 6.959000 -7.083862 +1021 1 2 0 5.689140 7.483124 -7.928906 +1022 1 2 0 4.722565 6.430009 -8.546693 +1023 1 3 0 3.693452 6.803359 -9.036911 +1024 1 4 0 6.540297 7.080673 -6.102459 +1025 1 4 0 4.958282 8.082892 -7.282649 +1026 1 2 0 6.303009 8.338869 -9.147185 +1027 1 2 0 6.962321 9.683020 -8.698706 +1028 1 2 0 6.113335 10.806050 -8.094806 +1029 1 3 0 5.314957 11.441914 -8.867803 +1030 1 3 0 6.281814 11.153556 -6.860003 +1031 1 4 0 5.501095 8.608142 -9.829181 +1032 1 4 0 7.017775 7.642829 -9.688511 +1033 1 4 0 7.483003 10.111296 -9.587458 +1034 1 4 0 7.840208 9.443341 -8.067185 +1035 1 1 0 4.989573 5.171451 -8.501981 +1036 1 2 0 4.030569 4.128878 -8.960795 +1037 1 2 0 2.659803 4.362057 -8.317970 +1038 1 3 0 2.633685 4.624499 -7.137127 +1039 1 4 0 5.932873 4.885550 -8.132184 +1040 1 4 0 3.970653 4.088976 -10.125056 +1041 1 2 0 4.547974 2.736928 -8.477716 +1042 1 3 0 5.739602 2.385810 -9.103937 +1043 1 4 0 3.830289 1.946588 -8.750291 +1044 1 4 0 4.757904 2.775726 -7.322086 +1045 1 4 0 6.399052 2.573026 -8.460448 +1046 1 1 0 1.554928 4.204648 -9.116288 +1047 1 2 0 0.143907 4.283937 -8.678656 +1048 1 2 0 -0.303717 2.830944 -8.588594 +1049 1 3 0 -0.192844 2.048979 -9.526722 +1050 1 4 0 1.755361 3.846256 -10.076285 +1051 1 4 0 0.145346 4.729291 -7.623107 +1052 1 2 0 -0.896382 4.990465 -9.602777 +1053 1 3 0 -0.546909 6.390258 -9.553197 +1054 1 2 0 -2.266687 5.014292 -9.040912 +1055 1 4 0 -0.839484 4.664962 -10.623152 +1056 1 4 0 -1.191403 6.852676 -10.030026 +1057 1 4 0 -2.370256 5.547925 -8.077780 +1058 1 4 0 -2.643323 3.985031 -8.945267 +1059 1 4 0 -3.015295 5.554521 -9.684458 +1060 1 1 0 -0.809824 2.397412 -7.387791 +1061 1 2 0 -1.543539 1.146508 -7.125034 +1062 1 2 0 -2.990030 1.446385 -7.471646 +1063 1 3 0 -3.473985 2.523645 -7.085299 +1064 1 4 0 -0.918513 3.078458 -6.559929 +1065 1 4 0 -1.082428 0.391021 -7.805730 +1066 1 2 0 -1.383109 0.737389 -5.704209 +1067 1 2 0 0.156980 0.778637 -5.025094 +1068 1 2 0 0.184063 0.045177 -3.655495 +1069 1 2 0 1.197637 0.213126 -5.986021 +1070 1 4 0 -1.814061 -0.254567 -5.578464 +1071 1 4 0 -2.073414 1.403223 -5.171331 +1072 1 4 0 0.570353 1.840354 -4.807618 +1073 1 4 0 -0.614353 0.329349 -2.926832 +1074 1 4 0 1.166261 0.241414 -3.114555 +1075 1 4 0 0.023700 -1.069031 -3.783533 +1076 1 4 0 2.158203 0.044818 -5.470973 +1077 1 4 0 1.222442 1.006598 -6.769381 +1078 1 4 0 0.965216 -0.653562 -6.606231 +1079 1 1 0 -3.781136 0.498160 -8.148625 +1080 1 2 0 -5.195999 0.627079 -8.395144 +1081 1 2 0 -5.839586 -0.173798 -7.325540 +1082 1 3 0 -5.682825 -1.396726 -7.207748 +1083 1 4 0 -3.423672 -0.475658 -8.058410 +1084 1 4 0 -5.466443 1.726348 -8.275345 +1085 1 2 0 -5.700075 0.093076 -9.698941 +1086 1 2 0 -5.439579 1.075796 -10.855403 +1087 1 1 0 -6.279526 2.029710 -11.458307 +1088 1 2 0 -4.192293 1.220658 -11.582303 +1089 1 2 0 -5.690995 2.592928 -12.533727 +1090 1 1 0 -4.422291 2.142927 -12.597346 +1091 1 4 0 -6.836699 -0.066381 -9.723009 +1092 1 4 0 -5.265040 -0.930234 -9.855749 +1093 1 4 0 -7.252692 2.264574 -11.108175 +1094 1 4 0 -3.349838 0.582035 -11.517840 +1095 1 4 0 -6.306793 3.255586 -13.155877 +1096 1 4 0 -3.777635 2.395819 -13.330102 +1097 1 1 0 -6.626714 0.438016 -6.407006 +1098 1 2 0 -7.321255 -0.209395 -5.260830 +1099 1 2 0 -8.726044 -0.540624 -5.779334 +1100 1 3 0 -9.643748 0.246853 -6.020516 +1101 1 4 0 -6.861887 1.458160 -6.506142 +1102 1 4 0 -6.783811 -1.126314 -4.931556 +1103 1 2 0 -7.394204 0.687745 -4.053531 +1104 1 2 0 -8.296909 0.064749 -2.869849 +1105 1 2 0 -7.951698 -1.454279 -2.487926 +1106 1 2 0 -8.060038 0.927044 -1.568059 +1107 1 4 0 -7.854595 1.761490 -4.347062 +1108 1 4 0 -6.360197 0.997945 -3.694450 +1109 1 4 0 -9.450918 0.148422 -3.062584 +1110 1 4 0 -7.020548 -1.637465 -1.993488 +1111 1 4 0 -7.993278 -2.155479 -3.352501 +1112 1 4 0 -8.718116 -1.826418 -1.776705 +1113 1 4 0 -6.906806 1.040935 -1.329769 +1114 1 4 0 -8.507678 0.388091 -0.676703 +1115 1 4 0 -8.513627 1.951825 -1.684662 +1116 1 1 0 -8.874500 -1.873711 -5.910632 +1117 1 2 0 -10.054693 -2.628336 -6.198564 +1118 1 2 0 -10.572111 -3.015072 -4.753004 +1119 1 3 0 -9.832635 -3.443205 -3.816546 +1120 1 4 0 -7.996568 -2.422971 -5.836674 +1121 1 4 0 -10.870694 -1.994424 -6.483439 +1122 1 2 0 -9.759279 -3.959835 -7.069730 +1123 1 2 0 -10.946970 -4.877626 -7.068986 +1124 1 2 0 -9.371460 -3.542046 -8.470112 +1125 1 4 0 -8.949402 -4.516022 -6.543614 +1126 1 4 0 -11.541359 -4.965020 -6.098983 +1127 1 4 0 -10.625500 -5.914327 -7.249472 +1128 1 4 0 -11.748695 -4.562709 -7.779917 +1129 1 4 0 -8.371018 -3.050033 -8.468892 +1130 1 4 0 -10.059019 -2.758287 -8.851634 +1131 1 4 0 -9.340042 -4.349447 -9.290806 +1132 1 1 0 -11.926250 -3.006119 -4.579854 +1133 1 2 0 -12.599868 -3.427499 -3.271795 +1134 1 2 0 -13.119425 -4.819080 -3.443024 +1135 1 3 0 -13.506292 -5.208366 -4.502651 +1136 1 4 0 -12.484786 -2.940272 -5.402807 +1137 1 4 0 -11.809544 -3.497303 -2.534649 +1138 1 2 0 -13.689712 -2.401148 -2.755481 +1139 1 2 0 -13.005610 -1.020901 -2.289793 +1140 1 2 0 -13.886801 0.170603 -2.491323 +1141 1 2 0 -12.530133 -1.092500 -0.802600 +1142 1 4 0 -14.252193 -2.898736 -1.884096 +1143 1 4 0 -14.401815 -2.226641 -3.620690 +1144 1 4 0 -12.072590 -0.884860 -2.820312 +1145 1 4 0 -13.445227 1.217778 -2.222189 +1146 1 4 0 -14.793098 0.063548 -1.909740 +1147 1 4 0 -14.187182 0.152067 -3.578149 +1148 1 4 0 -13.308581 -1.365227 -0.079185 +1149 1 4 0 -12.103016 -0.144811 -0.412295 +1150 1 4 0 -11.612023 -1.776214 -0.714294 +1151 1 1 0 -13.156998 -5.622978 -2.323616 +1152 1 2 0 -13.787861 -6.967978 -2.285282 +1153 1 2 0 -15.146212 -6.800506 -1.593340 +1154 1 3 0 -15.158053 -6.442067 -0.396674 +1155 1 4 0 -12.804286 -5.282526 -1.428142 +1156 1 4 0 -13.916618 -7.485164 -3.412935 +1157 1 2 0 -12.946414 -7.979280 -1.497063 +1158 1 2 0 -13.667631 -9.245528 -0.905442 +1159 1 2 0 -12.815857 -10.499980 -0.801429 +1160 1 1 0 -11.666913 -10.382988 0.124040 +1161 1 2 0 -10.598009 -11.176366 0.312631 +1162 1 1 0 -10.307009 -12.288930 -0.364431 +1163 1 1 0 -9.633279 -10.774307 1.106366 +1164 1 4 0 -12.386465 -7.607216 -0.581206 +1165 1 4 0 -12.215820 -8.370972 -2.244713 +1166 1 4 0 -14.479446 -9.568262 -1.529164 +1167 1 4 0 -14.129833 -9.168539 0.056180 +1168 1 4 0 -12.412465 -10.669174 -1.854364 +1169 1 4 0 -13.466079 -11.423733 -0.479836 +1170 1 4 0 -11.512692 -9.382182 0.495625 +1171 1 4 0 -10.805304 -12.650925 -1.216224 +1172 1 4 0 -9.470321 -12.815770 -0.049797 +1173 1 4 0 -9.791948 -9.915404 1.677222 +1174 1 4 0 -8.883682 -11.348748 1.394071 +1175 1 1 0 -16.257217 -7.220554 -2.308703 +1176 1 2 0 -17.613518 -7.141694 -1.748926 +1177 1 2 0 -17.781416 -8.219845 -0.663951 +1178 1 3 0 -17.284390 -9.348310 -0.956865 +1179 1 4 0 -16.199694 -7.696122 -3.255195 +1180 1 4 0 -17.779696 -6.166353 -1.252915 +1181 1 2 0 -18.748459 -7.363962 -2.843069 +1182 1 2 0 -18.849202 -6.260828 -3.989572 +1183 1 2 0 -19.614490 -6.870808 -5.148395 +1184 1 2 0 -19.500680 -4.982113 -3.494742 +1185 1 4 0 -19.731301 -7.397251 -2.283025 +1186 1 4 0 -18.632820 -8.422553 -3.243609 +1187 1 4 0 -17.781339 -6.071752 -4.343559 +1188 1 4 0 -19.542258 -6.264447 -6.144731 +1189 1 4 0 -20.684366 -6.894552 -4.987517 +1190 1 4 0 -19.302207 -7.942787 -5.285929 +1191 1 4 0 -19.636746 -4.174795 -4.365113 +1192 1 4 0 -18.901688 -4.545004 -2.684455 +1193 1 4 0 -20.591982 -5.186371 -3.176857 +1194 1 1 0 -18.472240 -7.923944 0.433190 +1195 1 2 0 -18.558377 -8.661913 1.684016 +1196 1 2 0 -19.865592 -8.197617 2.423657 +1197 1 3 0 -20.225574 -7.007408 2.517047 +1198 1 4 0 -19.018633 -7.045923 0.383040 +1199 1 4 0 -18.591712 -9.815151 1.449892 +1200 1 2 0 -17.330534 -8.352242 2.590189 +1201 1 2 0 -17.197501 -9.255175 3.894695 +1202 1 2 0 -15.917138 -8.993799 4.761448 +1203 1 1 0 -15.862754 -7.604311 5.340549 +1204 1 2 0 -14.953946 -7.213621 6.222257 +1205 1 1 0 -13.939504 -7.925565 6.768523 +1206 1 1 0 -15.231901 -6.019110 6.758979 +1207 1 4 0 -17.334188 -7.257380 2.696147 +1208 1 4 0 -16.422266 -8.568012 1.978366 +1209 1 4 0 -17.281791 -10.298139 3.520877 +1210 1 4 0 -18.121600 -9.053051 4.460330 +1211 1 4 0 -14.891329 -9.193895 4.266694 +1212 1 4 0 -16.028045 -9.747706 5.563074 +1213 1 4 0 -16.694442 -6.992689 5.266552 +1214 1 4 0 -13.473108 -8.806088 6.384760 +1215 1 4 0 -13.382022 -7.560903 7.513773 +1216 1 4 0 -16.061939 -5.573954 6.401806 +1217 1 4 0 -14.719788 -5.491070 7.406533 +1218 1 1 0 -20.555642 -9.238644 2.984101 +1219 1 2 0 -21.702627 -8.980829 3.816986 +1220 1 2 0 -22.667592 -10.144922 3.908536 +1221 1 3 0 -23.356911 -10.299018 4.988328 +1222 1 4 0 -20.172384 -10.204330 3.007070 +1223 1 4 0 -21.390921 -8.619000 4.839945 +1224 1 4 0 -22.324153 -8.174944 3.384408 +1225 1 1 0 -22.722375 -11.026698 2.860636 +1226 1 2 0 -23.459566 -12.247827 2.845542 +1227 1 2 0 -22.978621 -13.438108 1.985225 +1228 1 3 0 -23.756241 -13.995796 1.178096 +1229 1 4 0 -22.154953 -11.003456 1.998676 +1230 1 4 0 -23.492303 -12.585024 3.945342 +1231 1 4 0 -24.562029 -11.982169 2.632418 +1232 1 3 0 -21.741623 -13.731454 2.030156 +1233 2 6 0 -25.305889 -8.873286 2.603094 +1234 2 4 0 -26.195231 -8.788006 2.967312 +1235 2 4 0 -25.362163 -9.790033 2.275871 +1236 3 6 0 1.912477 -17.151817 -13.840126 +1237 3 4 0 1.018390 -17.464992 -13.630219 +1238 3 4 0 2.439262 -17.334772 -13.036215 +1239 4 6 0 8.975970 -6.483371 7.068342 +1240 4 4 0 8.251083 -5.855922 6.942323 +1241 4 4 0 9.786320 -5.989537 6.904165 +1242 5 6 0 -17.059429 -6.682892 -18.382532 +1243 5 4 0 -17.356881 -6.533480 -19.279335 +1244 5 4 0 -16.147993 -6.804945 -18.480643 +1245 6 6 0 11.369980 -7.303894 20.323145 +1246 6 4 0 10.458255 -7.203431 20.535809 +1247 6 4 0 11.777545 -7.941380 20.905100 +1248 7 6 0 3.047993 13.115234 13.513593 +1249 7 4 0 2.189597 12.815932 13.781761 +1250 7 4 0 3.351020 13.772449 14.197587 +1251 8 6 0 9.177488 -19.531354 -17.025005 +1252 8 4 0 8.997180 -19.923922 -17.884170 +1253 8 4 0 8.309703 -19.391487 -16.606802 +1254 9 6 0 -23.848340 -5.791211 7.441678 +1255 9 4 0 -24.004055 -6.746691 7.261738 +1256 9 4 0 -23.114081 -5.501409 6.867622 +1257 10 6 0 20.312209 0.171955 -11.773561 +1258 10 4 0 20.146745 1.095650 -12.020368 +1259 10 4 0 21.238842 0.205679 -11.456820 +1260 11 6 0 -22.314798 3.014770 5.149047 +1261 11 4 0 -22.929289 2.276522 4.980524 +1262 11 4 0 -22.201264 3.090196 6.138941 +1263 12 6 0 26.239381 8.286972 11.597675 +1264 12 4 0 26.254621 7.398022 11.997034 +1265 12 4 0 26.842192 8.820608 12.190091 +1266 13 6 0 1.081563 20.255845 0.892389 +1267 13 4 0 0.921065 19.278377 0.845371 +1268 13 4 0 1.812904 20.277503 0.290341 +1269 14 6 0 -25.838005 -18.994104 1.429638 +1270 14 4 0 -26.326160 -18.188143 1.703932 +1271 14 4 0 -25.342908 -19.303427 2.200872 +1272 15 6 0 -20.846054 -7.092652 6.478370 +1273 15 4 0 -20.166552 -7.554414 6.018306 +1274 15 4 0 -21.115422 -7.596368 7.225200 +1275 16 6 0 25.160173 -4.728893 -15.381523 +1276 16 4 0 24.661069 -4.062502 -14.979503 +1277 16 4 0 25.990165 -4.238213 -15.567710 +1278 17 6 0 14.535913 -19.677013 15.675709 +1279 17 4 0 14.037278 -20.588075 15.600840 +1280 17 4 0 14.211502 -19.181601 14.912412 +1281 18 6 0 2.857645 5.855417 4.079262 +1282 18 4 0 3.430506 5.710138 4.830199 +1283 18 4 0 2.475458 6.741420 4.276791 +1284 19 6 0 -27.372739 -15.194690 -19.205198 +1285 19 4 0 -28.210581 -15.653921 -19.162899 +1286 19 4 0 -27.456185 -14.667250 -19.960242 +1287 20 6 0 17.781541 0.602750 -19.513277 +1288 20 4 0 17.110642 0.664367 -18.792643 +1289 20 4 0 18.099117 1.530660 -19.555262 +1290 21 6 0 8.088032 9.439765 10.567445 +1291 21 4 0 8.015346 10.287070 10.169518 +1292 21 4 0 8.124832 9.462611 11.569641 +1293 22 6 0 15.345860 8.714934 -11.152067 +1294 22 4 0 15.658920 9.075500 -11.972725 +1295 22 4 0 14.523818 9.211910 -11.028938 +1296 23 6 0 11.013253 17.283874 -4.348263 +1297 23 4 0 10.789838 18.205570 -4.504969 +1298 23 4 0 10.260676 16.779106 -4.055437 +1299 24 6 0 -12.889592 -16.760154 20.387880 +1300 24 4 0 -13.380671 -16.152118 19.799845 +1301 24 4 0 -13.369275 -16.639729 21.191087 +1302 25 6 0 25.866516 4.706708 -8.061449 +1303 25 4 0 25.769362 4.461317 -8.965208 +1304 25 4 0 25.764828 5.656105 -8.114825 +1305 26 6 0 -26.248807 10.809987 -17.556369 +1306 26 4 0 -25.862537 10.639607 -16.669023 +1307 26 4 0 -25.586772 10.275331 -18.075376 +1308 27 6 0 5.011891 -0.095276 11.102149 +1309 27 4 0 5.950070 -0.328570 10.928116 +1310 27 4 0 4.658035 -0.692033 11.838618 +1311 28 6 0 -3.238023 12.776925 -11.754925 +1312 28 4 0 -3.559468 13.177496 -12.562608 +1313 28 4 0 -2.242036 12.949361 -11.730152 +1314 29 6 0 7.608155 6.209090 6.533228 +1315 29 4 0 6.751309 6.368791 6.939913 +1316 29 4 0 7.470608 5.288476 6.273733 +1317 30 6 0 14.666135 -14.922987 -11.755230 +1318 30 4 0 14.581988 -14.800079 -10.784928 +1319 30 4 0 15.226569 -14.207434 -12.104465 +1320 31 6 0 15.326386 3.732831 -20.745668 +1321 31 4 0 14.863781 4.277641 -20.063559 +1322 31 4 0 14.723700 3.157686 -21.298124 +1323 32 6 0 18.627348 -11.469990 6.467592 +1324 32 4 0 19.047503 -12.239416 6.986935 +1325 32 4 0 19.345653 -10.823603 6.332871 +1326 33 6 0 -14.220347 1.309533 12.809953 +1327 33 4 0 -15.112916 1.674865 12.966390 +1328 33 4 0 -13.905824 1.691626 11.972749 +1329 34 6 0 17.738294 20.743473 -0.318702 +1330 34 4 0 16.798924 21.074482 -0.373811 +1331 34 4 0 18.299449 21.160545 -1.000515 +1332 35 6 0 20.455752 2.132791 12.340284 +1333 35 4 0 19.810773 1.395571 12.257305 +1334 35 4 0 20.198026 2.647549 11.503824 +1335 36 6 0 9.853022 -4.726683 18.073966 +1336 36 4 0 9.922207 -4.319154 18.942345 +1337 36 4 0 10.745493 -4.795112 17.634995 +1338 37 6 0 22.828162 7.406766 18.911442 +1339 37 4 0 23.277041 7.740752 18.085874 +1340 37 4 0 21.875678 7.287001 18.697167 +1341 38 6 0 12.857348 6.858682 -2.850558 +1342 38 4 0 12.349544 7.638411 -2.700800 +1343 38 4 0 13.434641 6.773930 -2.100368 +1344 39 6 0 10.156535 2.406121 -18.658294 +1345 39 4 0 10.409878 1.989225 -19.465922 +1346 39 4 0 9.490048 3.103188 -18.852928 +1347 40 6 0 12.554233 20.216080 19.570476 +1348 40 4 0 11.705682 19.810667 19.782475 +1349 40 4 0 12.468266 20.347772 18.588160 +1350 41 6 0 -1.134276 6.357754 18.934733 +1351 41 4 0 -1.973226 6.075942 19.245633 +1352 41 4 0 -0.442075 6.043387 19.552910 +1353 42 6 0 1.750577 4.009032 13.244051 +1354 42 4 0 1.218838 4.545834 13.791599 +1355 42 4 0 1.398756 3.100724 13.349288 +1356 43 6 0 2.689021 16.465513 4.587974 +1357 43 4 0 3.467483 16.279752 5.178457 +1358 43 4 0 3.010897 17.110882 3.971315 +1359 44 6 0 22.627367 7.401815 -6.857148 +1360 44 4 0 21.892213 7.078953 -7.539727 +1361 44 4 0 22.599466 6.767179 -6.162623 +1362 45 6 0 -24.350411 -14.025041 19.899958 +1363 45 4 0 -23.879390 -13.314568 19.375377 +1364 45 4 0 -25.008554 -14.400223 19.294992 +1365 46 6 0 18.357304 9.543924 6.204099 +1366 46 4 0 18.326985 9.093740 5.378574 +1367 46 4 0 19.117744 9.183856 6.709862 +1368 47 6 0 21.017970 -11.520615 -11.071883 +1369 47 4 0 21.726613 -10.894899 -10.978046 +1370 47 4 0 20.726915 -11.629983 -10.116083 +1371 48 6 0 -26.667012 4.365972 15.083664 +1372 48 4 0 -27.091443 3.550925 15.267577 +1373 48 4 0 -25.989136 4.193758 14.444620 +1374 49 6 0 12.781386 0.642540 16.526237 +1375 49 4 0 13.038723 1.476289 17.006927 +1376 49 4 0 12.089659 0.933072 15.871227 +1377 50 6 0 -27.429715 -6.725581 8.240721 +1378 50 4 0 -26.910936 -6.564480 7.470893 +1379 50 4 0 -28.162464 -7.327953 7.969065 +1380 51 6 0 24.070362 5.174514 -0.911512 +1381 51 4 0 24.629840 5.966148 -0.705486 +1382 51 4 0 23.362520 5.287238 -1.509298 +1383 52 6 0 16.846666 -16.995462 -13.603864 +1384 52 4 0 15.867560 -16.748669 -13.456021 +1385 52 4 0 17.071846 -16.254095 -14.246763 +1386 53 6 0 20.841116 12.797120 17.009497 +1387 53 4 0 20.969187 13.669803 17.421731 +1388 53 4 0 21.771225 12.416689 16.764510 +1389 54 6 0 -19.221734 -18.875573 -10.983743 +1390 54 4 0 -20.186979 -18.779925 -10.982038 +1391 54 4 0 -19.009681 -19.369621 -10.158798 +1392 55 6 0 -18.683521 -20.505972 -16.031221 +1393 55 4 0 -19.618898 -20.618800 -16.082058 +1394 55 4 0 -18.315789 -21.292104 -15.650396 +1395 56 6 0 13.486524 6.749112 5.293446 +1396 56 4 0 13.961609 6.056192 4.983058 +1397 56 4 0 12.780504 7.007906 4.716738 +1398 57 6 0 20.810382 20.409198 13.765268 +1399 57 4 0 21.268029 20.454532 14.598864 +1400 57 4 0 19.895912 20.318361 13.998352 +1401 58 6 0 20.363727 -12.785030 1.387420 +1402 58 4 0 20.625728 -12.042183 1.970150 +1403 58 4 0 19.472843 -13.114509 1.692870 +1404 59 6 0 -4.110768 13.121183 -4.644500 +1405 59 4 0 -3.600734 12.558925 -4.032909 +1406 59 4 0 -4.403120 13.867412 -4.044378 +1407 60 6 0 -21.061840 -7.740629 20.493954 +1408 60 4 0 -21.039453 -7.543946 19.536841 +1409 60 4 0 -21.757349 -7.146898 20.900973 +1410 61 6 0 26.211082 -13.851944 -14.351632 +1411 61 4 0 26.688652 -13.578058 -13.560156 +1412 61 4 0 25.237610 -13.844318 -14.168406 +1413 62 6 0 7.682001 -20.605822 4.285305 +1414 62 4 0 8.364066 -21.007718 3.810153 +1415 62 4 0 7.192709 -19.999465 3.748655 +1416 63 6 0 22.004930 15.161537 5.915259 +1417 63 4 0 22.529069 15.401145 5.140758 +1418 63 4 0 21.836857 14.241604 6.044353 +1419 64 6 0 21.713613 -17.900383 3.815703 +1420 64 4 0 22.679247 -17.725384 3.950726 +1421 64 4 0 21.695664 -18.649618 3.180406 +1422 65 6 0 11.567159 -18.128823 12.553393 +1423 65 4 0 11.856655 -17.178344 12.428270 +1424 65 4 0 11.248307 -18.230630 13.449380 +1425 66 6 0 -22.622068 18.057993 -12.095565 +1426 66 4 0 -21.694228 17.853670 -11.941877 +1427 66 4 0 -22.819172 17.835208 -12.993248 +1428 67 6 0 9.275007 12.390062 -11.584253 +1429 67 4 0 8.977379 13.016934 -10.914605 +1430 67 4 0 10.127813 12.041771 -11.232361 +1431 68 6 0 -14.822916 -15.989738 9.135198 +1432 68 4 0 -14.194812 -16.628214 9.459309 +1433 68 4 0 -14.342626 -15.188459 9.014917 +1434 69 6 0 -11.828358 -9.561319 -4.583271 +1435 69 4 0 -12.150096 -9.065398 -5.351378 +1436 69 4 0 -12.516681 -10.185548 -4.230080 +1437 70 6 0 -10.898855 6.281982 -10.651011 +1438 70 4 0 -11.533704 6.844824 -10.249357 +1439 70 4 0 -10.394778 5.928734 -9.945580 +1440 71 6 0 10.206251 18.878731 19.697794 +1441 71 4 0 10.128033 18.397864 20.526746 +1442 71 4 0 9.368907 19.321892 19.635002 +1443 72 6 0 7.056097 15.592239 15.029949 +1444 72 4 0 7.186116 15.478315 14.072096 +1445 72 4 0 7.414569 14.832987 15.435389 +1446 73 6 0 24.543977 3.489901 -14.044452 +1447 73 4 0 23.682275 3.287251 -13.651175 +1448 73 4 0 24.372867 3.165473 -14.930902 +1449 74 6 0 -0.579079 -10.101283 9.711937 +1450 74 4 0 -1.148742 -10.353328 9.005933 +1451 74 4 0 -0.914837 -9.213566 9.976954 +1452 75 6 0 6.810722 17.081705 -5.703105 +1453 75 4 0 5.903603 16.716054 -5.813888 +1454 75 4 0 7.038830 17.199405 -6.631357 +1455 76 6 0 -26.352729 7.462163 20.420411 +1456 76 4 0 -27.199047 7.711650 20.831378 +1457 76 4 0 -26.411228 7.671245 19.444854 +1458 77 6 0 17.042652 1.713603 8.364686 +1459 77 4 0 16.951087 0.795520 8.175385 +1460 77 4 0 16.736372 2.035025 7.509624 +1461 78 6 0 19.131873 19.334012 -6.335242 +1462 78 4 0 18.416265 18.729295 -6.454050 +1463 78 4 0 19.910836 18.805924 -6.078777 +1464 79 6 0 7.310440 -10.543485 13.587642 +1465 79 4 0 6.863481 -11.404338 13.838041 +1466 79 4 0 6.716557 -9.980934 13.023023 +1467 80 6 0 16.655451 5.245734 12.848556 +1468 80 4 0 17.418946 5.791006 12.911180 +1469 80 4 0 16.851104 4.455072 13.419371 +1470 81 6 0 -11.098331 12.748199 -7.329972 +1471 81 4 0 -11.009338 13.599863 -7.754046 +1472 81 4 0 -12.065844 12.538087 -7.393876 +1473 82 6 0 -12.334041 -5.457784 -13.381783 +1474 82 4 0 -12.711013 -4.568395 -13.257780 +1475 82 4 0 -11.461517 -5.234972 -13.709702 +1476 83 6 0 -19.619563 15.046747 6.026220 +1477 83 4 0 -19.064160 15.888434 5.869584 +1478 83 4 0 -20.197675 14.948767 5.270745 +1479 84 6 0 19.403362 5.853957 6.190263 +1480 84 4 0 18.497327 6.115780 6.469846 +1481 84 4 0 20.017752 6.471645 6.487352 +1482 85 6 0 -25.726372 -3.750023 6.981390 +1483 85 4 0 -26.510590 -3.855351 7.566875 +1484 85 4 0 -25.108784 -4.364237 7.293376 +1485 86 6 0 19.363936 -15.722056 8.477199 +1486 86 4 0 19.376520 -16.156352 9.371325 +1487 86 4 0 20.131991 -16.106093 8.026790 +1488 87 6 0 4.918015 16.654603 6.129016 +1489 87 4 0 5.581517 17.300026 5.845056 +1490 87 4 0 5.390842 15.802197 6.094486 +1491 88 6 0 6.078733 16.693115 -13.842069 +1492 88 4 0 5.199251 16.442614 -14.064650 +1493 88 4 0 6.443869 16.763088 -14.767416 +1494 89 6 0 21.731326 -12.551581 -19.815904 +1495 89 4 0 21.519077 -11.572592 -19.819800 +1496 89 4 0 21.264568 -12.901316 -18.987186 +1497 90 6 0 24.487045 0.545827 12.845924 +1498 90 4 0 24.038085 0.883409 12.081688 +1499 90 4 0 24.083597 0.980384 13.591108 +1500 91 6 0 18.410889 -13.655540 -1.593840 +1501 91 4 0 18.336634 -14.202424 -0.852695 +1502 91 4 0 19.187521 -13.942267 -2.059694 +1503 92 6 0 10.380738 17.460434 -20.015294 +1504 92 4 0 9.800569 16.677901 -20.098710 +1505 92 4 0 10.044263 17.935616 -19.257888 +1506 93 6 0 13.540400 13.359091 -2.277273 +1507 93 4 0 13.918768 14.199197 -2.621352 +1508 93 4 0 13.546416 13.374894 -1.268707 +1509 94 6 0 19.550822 -15.885302 -17.171256 +1510 94 4 0 19.618925 -16.577230 -17.813037 +1511 94 4 0 20.364869 -15.924821 -16.745913 +1512 95 6 0 8.934453 -16.027660 20.082161 +1513 95 4 0 8.350825 -15.432721 20.504320 +1514 95 4 0 9.504005 -15.407057 19.696244 +1515 96 6 0 13.449317 -0.696209 -11.399773 +1516 96 4 0 14.259684 -0.816041 -10.861718 +1517 96 4 0 12.841649 -1.407477 -11.030433 +1518 97 6 0 21.159598 -20.230615 11.116255 +1519 97 4 0 20.955379 -21.039069 10.677683 +1520 97 4 0 21.227629 -20.467861 12.046012 +1521 98 6 0 -11.425719 10.313603 15.561621 +1522 98 4 0 -11.752060 9.489612 15.149018 +1523 98 4 0 -12.009787 11.024201 15.339594 +1524 99 6 0 23.530234 5.073332 12.308815 +1525 99 4 0 23.411228 4.192303 12.037314 +1526 99 4 0 23.017800 5.539035 11.565588 +1527 100 6 0 9.285394 15.401019 4.247587 +1528 100 4 0 9.029223 16.111512 4.827382 +1529 100 4 0 9.908946 14.931813 4.786975 +1530 101 6 0 26.710953 10.879732 17.565984 +1531 101 4 0 26.481837 11.014223 18.458503 +1532 101 4 0 26.801930 11.751805 17.193691 +1533 102 6 0 26.059219 -18.322514 -8.230640 +1534 102 4 0 25.468209 -17.831491 -8.807599 +1535 102 4 0 26.660395 -17.588693 -7.832128 +1536 103 6 0 7.573847 10.494945 -13.000340 +1537 103 4 0 6.752773 10.585941 -12.508913 +1538 103 4 0 8.060915 11.203548 -12.596091 +1539 104 6 0 16.495334 16.907261 -17.264088 +1540 104 4 0 15.936311 17.701142 -17.215765 +1541 104 4 0 16.146725 16.404479 -17.972530 +1542 105 6 0 12.550501 12.792681 0.441559 +1543 105 4 0 12.890193 12.783948 1.424080 +1544 105 4 0 12.972043 11.976735 0.117581 +1545 106 6 0 6.804544 2.469256 9.043785 +1546 106 4 0 7.053760 2.925055 9.856512 +1547 106 4 0 7.365554 1.678918 9.065958 +1548 107 6 0 -26.111190 11.845380 12.004953 +1549 107 4 0 -26.772515 12.430684 11.621087 +1550 107 4 0 -25.209540 12.292191 11.872070 +1551 108 6 0 -10.314383 -9.317643 -12.200930 +1552 108 4 0 -11.268643 -8.984584 -12.345854 +1553 108 4 0 -10.432002 -10.035760 -11.529786 +1554 109 6 0 -26.380108 15.118882 -9.622008 +1555 109 4 0 -25.930871 15.887042 -9.924512 +1556 109 4 0 -25.979073 14.306361 -10.084998 +1557 110 6 0 1.139515 -19.714505 -8.279716 +1558 110 4 0 0.675447 -19.100241 -8.876686 +1559 110 4 0 1.861101 -19.991496 -8.757935 +1560 111 6 0 17.452914 16.822171 9.920464 +1561 111 4 0 17.934078 17.151660 9.199989 +1562 111 4 0 17.980199 16.103548 10.329451 +1563 112 6 0 18.740004 -12.107924 14.391777 +1564 112 4 0 19.596584 -12.274465 14.867937 +1565 112 4 0 18.902733 -12.244474 13.491103 +1566 113 6 0 -15.579375 6.511760 13.017065 +1567 113 4 0 -15.193219 7.321701 12.610540 +1568 113 4 0 -15.093538 5.769586 12.622079 +1569 114 6 0 -0.877815 -3.636485 14.316002 +1570 114 4 0 -1.480812 -3.188883 14.944590 +1571 114 4 0 -1.224311 -3.235271 13.526942 +1572 115 6 0 7.516564 -9.888221 20.928138 +1573 115 4 0 7.083616 -9.984725 20.119275 +1574 115 4 0 7.035439 -10.492537 21.460270 +1575 116 6 0 26.972175 15.513650 13.835965 +1576 116 4 0 27.290530 14.677325 14.220401 +1577 116 4 0 26.022826 15.628989 13.956832 +1578 117 6 0 18.373056 16.436866 -9.784173 +1579 117 4 0 18.173740 16.705423 -10.702898 +1580 117 4 0 19.003590 17.095921 -9.494087 +1581 118 6 0 -2.499599 -10.235115 -18.681799 +1582 118 4 0 -2.484635 -9.679910 -17.855014 +1583 118 4 0 -1.762196 -9.952193 -19.147621 +1584 119 6 0 2.170631 9.696760 -13.707491 +1585 119 4 0 2.410831 10.573952 -14.022044 +1586 119 4 0 1.366528 9.911718 -13.203660 +1587 120 6 0 -22.060495 0.084333 -19.330968 +1588 120 4 0 -21.759145 -0.801023 -19.628154 +1589 120 4 0 -21.345397 0.598803 -18.978005 +1590 121 6 0 20.717073 -0.364667 -3.266977 +1591 121 4 0 20.064258 -0.869174 -2.840894 +1592 121 4 0 20.978768 -0.863225 -4.123117 +1593 122 6 0 -11.693545 -17.585832 12.155919 +1594 122 4 0 -11.693581 -16.618165 12.297539 +1595 122 4 0 -10.965597 -17.630843 11.482629 +1596 123 6 0 22.033287 -5.610818 11.814279 +1597 123 4 0 21.603774 -4.969289 11.213082 +1598 123 4 0 22.863855 -5.854126 11.399621 +1599 124 6 0 -4.245364 20.530679 -11.580108 +1600 124 4 0 -4.613077 20.058542 -10.812152 +1601 124 4 0 -4.869612 21.297733 -11.750599 +1602 125 6 0 20.837886 3.849343 18.187160 +1603 125 4 0 21.637221 4.154388 17.767478 +1604 125 4 0 20.753725 4.316852 19.044680 +1605 126 6 0 4.000998 20.642070 6.993614 +1606 126 4 0 3.097228 20.600441 6.539412 +1607 126 4 0 4.007858 20.203528 7.895914 +1608 127 6 0 11.947977 15.441293 -0.469120 +1609 127 4 0 11.971275 14.454085 -0.273912 +1610 127 4 0 12.470807 15.488877 -1.291943 +1611 128 6 0 3.007637 18.543541 -2.984774 +1612 128 4 0 3.565232 17.725540 -3.038270 +1613 128 4 0 2.929337 18.913789 -3.837866 +1614 129 6 0 8.597796 -3.024177 11.307241 +1615 129 4 0 9.440361 -2.907621 10.794269 +1616 129 4 0 8.194484 -3.777321 10.948431 +1617 130 6 0 12.969092 -7.932168 -3.416690 +1618 130 4 0 12.657272 -8.671538 -3.962914 +1619 130 4 0 13.930699 -7.927015 -3.644128 +1620 131 6 0 4.690692 11.990242 6.047085 +1621 131 4 0 3.830915 11.620745 5.794047 +1622 131 4 0 5.366958 11.770788 5.369987 +1623 132 6 0 10.838100 15.915400 -16.690449 +1624 132 4 0 11.719066 16.216650 -16.583824 +1625 132 4 0 10.351788 16.668150 -17.062399 +1626 133 6 0 20.760419 3.237669 6.554876 +1627 133 4 0 20.210628 2.565167 6.189576 +1628 133 4 0 20.243367 4.047032 6.450547 +1629 134 6 0 -7.351853 -2.751166 -10.694739 +1630 134 4 0 -8.277520 -2.829710 -11.023595 +1631 134 4 0 -6.973902 -2.027001 -11.286243 +1632 135 6 0 8.338680 -14.152925 -14.216839 +1633 135 4 0 7.907963 -14.913791 -13.766433 +1634 135 4 0 9.057618 -14.554948 -14.672432 +1635 136 6 0 -21.745003 -1.600080 -8.484704 +1636 136 4 0 -22.396276 -0.906185 -8.690601 +1637 136 4 0 -21.042086 -1.417961 -9.157366 +1638 137 6 0 24.505779 -7.277316 -14.651231 +1639 137 4 0 24.835649 -6.369110 -14.893362 +1640 137 4 0 24.135101 -7.595011 -15.516575 +1641 138 6 0 13.325591 -5.149951 -6.169737 +1642 138 4 0 14.291969 -5.289577 -6.041288 +1643 138 4 0 12.813376 -5.844865 -5.785812 +1644 139 6 0 -20.933242 20.161591 -8.696079 +1645 139 4 0 -20.088965 20.396502 -9.157616 +1646 139 4 0 -21.417399 20.940524 -8.320759 +1647 140 6 0 22.832947 -8.348413 -10.288572 +1648 140 4 0 23.575495 -7.724229 -10.313126 +1649 140 4 0 23.029160 -9.044226 -9.677546 +1650 141 6 0 23.743445 2.427859 19.849750 +1651 141 4 0 24.532045 1.907225 19.711678 +1652 141 4 0 23.062926 1.994077 19.368217 +1653 142 6 0 10.589993 1.639740 20.516878 +1654 142 4 0 9.987052 1.032362 20.047348 +1655 142 4 0 10.624644 2.472330 20.027640 +1656 143 6 0 6.500815 -17.047237 7.812429 +1657 143 4 0 7.407059 -16.956263 7.440866 +1658 143 4 0 6.013508 -17.774059 7.384568 +1659 144 6 0 -0.199269 -9.380208 -16.449921 +1660 144 4 0 -0.920685 -8.715985 -16.515053 +1661 144 4 0 0.387469 -9.304809 -17.255371 +1662 145 6 0 6.245654 20.180381 -12.940075 +1663 145 4 0 5.376160 20.220616 -13.392701 +1664 145 4 0 6.857081 19.702851 -13.499407 +1665 146 6 0 -4.928957 -20.301289 11.340442 +1666 146 4 0 -4.017513 -20.158995 11.049259 +1667 146 4 0 -4.923799 -20.953195 11.990322 +1668 147 6 0 -11.515851 -8.388468 19.647979 +1669 147 4 0 -11.184791 -8.359618 20.524675 +1670 147 4 0 -12.443923 -8.327763 19.606292 +1671 148 6 0 -24.167509 7.194575 -0.837148 +1672 148 4 0 -24.972654 7.649920 -1.275517 +1673 148 4 0 -24.204709 7.474688 0.131591 +1674 149 6 0 12.126351 -16.062203 11.096539 +1675 149 4 0 11.280449 -15.927172 10.574646 +1676 149 4 0 12.611089 -15.288570 10.879908 +1677 150 6 0 -7.169287 5.827131 17.736258 +1678 150 4 0 -6.956548 5.152949 17.035326 +1679 150 4 0 -6.291387 6.127541 18.098754 +1680 151 6 0 -19.820265 12.907447 16.581358 +1681 151 4 0 -19.659011 12.980070 17.534136 +1682 151 4 0 -20.478433 13.648938 16.483830 +1683 152 6 0 10.474631 10.634400 -7.924386 +1684 152 4 0 10.794363 11.386619 -7.409132 +1685 152 4 0 9.591861 10.377005 -7.560987 +1686 153 6 0 9.869765 7.468088 9.667232 +1687 153 4 0 9.072542 8.000794 9.695304 +1688 153 4 0 10.102662 7.299293 8.720054 +1689 154 6 0 11.149756 9.562904 -12.765396 +1690 154 4 0 10.686250 9.267978 -11.959062 +1691 154 4 0 11.324858 8.766817 -13.298380 +1692 155 6 0 -8.591767 12.757143 -4.012695 +1693 155 4 0 -8.324896 13.003317 -4.932948 +1694 155 4 0 -8.147829 13.384049 -3.416515 +1695 156 6 0 4.774504 19.024876 15.999665 +1696 156 4 0 4.160294 19.017277 16.757162 +1697 156 4 0 5.517925 18.569472 16.400595 +1698 157 6 0 -4.714429 -2.091345 19.353537 +1699 157 4 0 -4.854280 -2.828837 19.971329 +1700 157 4 0 -5.535288 -2.163222 18.793806 +1701 158 6 0 3.570216 -18.611817 -15.598378 +1702 158 4 0 3.046765 -18.582990 -16.425866 +1703 158 4 0 3.158896 -17.918154 -15.032600 +1704 159 6 0 -11.657691 18.235653 20.509864 +1705 159 4 0 -12.226759 18.986315 20.717707 +1706 159 4 0 -11.080397 18.121952 21.271087 +1707 160 6 0 14.493937 -0.382813 19.719393 +1708 160 4 0 13.979118 -0.142020 20.470391 +1709 160 4 0 15.349953 -0.432678 20.118874 +1710 161 6 0 -25.714868 -12.047610 -14.994953 +1711 161 4 0 -25.527994 -12.236118 -16.000515 +1712 161 4 0 -24.876261 -11.553460 -14.748410 +1713 162 6 0 6.325847 -15.764455 11.544131 +1714 162 4 0 6.229128 -16.154079 12.417251 +1715 162 4 0 6.886521 -15.002890 11.743125 +1716 163 6 0 -27.331883 9.233246 15.237568 +1717 163 4 0 -26.599380 9.867873 14.994627 +1718 163 4 0 -27.264332 8.495991 14.623286 +1719 164 6 0 -25.207375 -3.847132 17.095096 +1720 164 4 0 -25.445321 -4.629286 16.543803 +1721 164 4 0 -25.823438 -3.158780 16.776808 +1722 165 6 0 -2.766266 -13.179260 4.266317 +1723 165 4 0 -1.896026 -13.215786 3.757612 +1724 165 4 0 -3.151612 -14.038152 4.175240 +1725 166 6 0 17.165111 16.676060 6.100929 +1726 166 4 0 17.064451 17.522432 6.606579 +1727 166 4 0 16.942925 15.940574 6.655125 +1728 167 6 0 -18.331646 7.552754 -8.484008 +1729 167 4 0 -18.933791 7.004225 -7.919061 +1730 167 4 0 -18.900890 7.785944 -9.196075 +1731 168 6 0 26.169311 3.132717 9.584634 +1732 168 4 0 26.518912 3.613350 10.302634 +1733 168 4 0 25.680453 2.435972 9.901377 +1734 169 6 0 1.192323 17.107553 -8.736586 +1735 169 4 0 1.021901 17.797734 -9.422544 +1736 169 4 0 0.892750 17.475660 -7.885822 +1737 170 6 0 -25.815030 10.180500 5.376868 +1738 170 4 0 -26.459337 10.344257 6.080597 +1739 170 4 0 -25.337134 9.352614 5.563562 +1740 171 6 0 9.219642 -20.775000 0.193729 +1741 171 4 0 9.939354 -21.194791 -0.335512 +1742 171 4 0 8.458200 -21.122557 -0.245347 +1743 172 6 0 7.419149 -15.012981 -7.052183 +1744 172 4 0 7.072086 -14.800593 -6.138570 +1745 172 4 0 6.878848 -15.717530 -7.366638 +1746 173 6 0 18.623745 10.156288 3.028217 +1747 173 4 0 17.982257 9.440233 2.875628 +1748 173 4 0 18.009023 10.975494 3.182536 +1749 174 6 0 13.145546 -20.676260 -16.694649 +1750 174 4 0 12.815312 -20.227755 -17.488442 +1751 174 4 0 12.786182 -21.555938 -16.737351 +1752 175 6 0 4.910310 -17.490236 -1.378014 +1753 175 4 0 5.657779 -17.456107 -0.820623 +1754 175 4 0 5.268563 -17.934730 -2.200934 +1755 176 6 0 -0.270185 6.286195 9.930733 +1756 176 4 0 -0.856415 6.001917 10.611025 +1757 176 4 0 0.005563 7.171058 10.176397 +1758 177 6 0 -3.229650 16.643646 19.387659 +1759 177 4 0 -3.312058 16.163949 18.538257 +1760 177 4 0 -2.782251 17.481594 19.257422 +1761 178 6 0 -16.368157 2.960013 13.098824 +1762 178 4 0 -16.360100 3.430962 13.984851 +1763 178 4 0 -16.773065 3.567928 12.508334 +1764 179 6 0 19.447080 -6.209321 9.611666 +1765 179 4 0 18.833539 -5.622887 9.193795 +1766 179 4 0 18.949525 -6.526265 10.384214 +1767 180 6 0 -8.044280 -4.288816 -16.207882 +1768 180 4 0 -7.966109 -3.883769 -17.074640 +1769 180 4 0 -7.261903 -4.793399 -15.982149 +1770 181 6 0 20.024947 17.270827 14.758218 +1771 181 4 0 19.172341 17.478642 15.170634 +1772 181 4 0 20.700921 17.006922 15.403538 +1773 182 6 0 24.735763 -12.617736 3.782055 +1774 182 4 0 24.742238 -13.518522 3.370896 +1775 182 4 0 25.350602 -12.232493 3.147824 +1776 183 6 0 3.431414 8.925671 6.826679 +1777 183 4 0 3.084862 8.827163 7.759644 +1778 183 4 0 4.424412 9.107829 6.895448 +1779 184 6 0 17.489102 -11.319977 19.702626 +1780 184 4 0 18.434347 -11.550903 19.419885 +1781 184 4 0 16.965653 -12.122535 19.583109 +1782 185 6 0 13.274816 16.183286 -2.849704 +1783 185 4 0 13.777976 16.949053 -2.573649 +1784 185 4 0 12.549844 16.546466 -3.345363 +1785 186 6 0 23.841910 -13.944818 11.597095 +1786 186 4 0 23.043336 -14.386099 11.958056 +1787 186 4 0 23.668687 -13.015455 11.845078 +1788 187 6 0 14.458157 -17.498951 -20.684884 +1789 187 4 0 13.916318 -16.687121 -20.523929 +1790 187 4 0 14.348004 -17.977683 -19.850686 +1791 188 6 0 -8.369104 15.140447 -19.622301 +1792 188 4 0 -9.156426 14.702367 -19.949175 +1793 188 4 0 -7.765440 15.416867 -20.299390 +1794 189 6 0 19.145293 -12.193056 11.874609 +1795 189 4 0 18.766654 -11.373734 11.579591 +1796 189 4 0 18.521350 -12.726230 11.327543 +1797 190 6 0 -18.076775 18.801612 -14.295021 +1798 190 4 0 -18.586562 18.486836 -15.063616 +1799 190 4 0 -18.385853 18.166574 -13.559441 +1800 191 6 0 -19.106085 17.513715 -16.406412 +1801 191 4 0 -18.423458 17.909352 -17.009956 +1802 191 4 0 -19.076533 16.547362 -16.469991 +1803 192 6 0 8.044684 -0.011875 -10.373353 +1804 192 4 0 8.668860 -0.626009 -9.915411 +1805 192 4 0 8.602268 0.704634 -10.757756 +1806 193 6 0 -23.287552 -7.074362 17.929889 +1807 193 4 0 -22.370365 -7.411352 17.793085 +1808 193 4 0 -23.082861 -6.243551 18.339191 +1809 194 6 0 22.099315 -0.856463 5.137385 +1810 194 4 0 22.143526 -1.231806 5.942781 +1811 194 4 0 22.809699 -1.264756 4.609180 +1812 195 6 0 11.618777 5.171830 -12.366225 +1813 195 4 0 12.078170 4.347700 -12.198463 +1814 195 4 0 10.837551 5.069580 -11.726531 +1815 196 6 0 13.014153 9.452672 -20.836207 +1816 196 4 0 13.647981 9.913017 -20.352836 +1817 196 4 0 13.495084 8.718233 -21.270254 +1818 197 6 0 12.425877 4.164162 0.171584 +1819 197 4 0 12.703840 3.756309 0.988868 +1820 197 4 0 12.991444 5.029213 0.073462 +1821 198 6 0 -9.835180 14.629378 -13.804396 +1822 198 4 0 -9.610077 14.944151 -14.684564 +1823 198 4 0 -8.989021 14.154277 -13.615953 +1824 199 6 0 -2.408060 19.252237 0.880939 +1825 199 4 0 -2.493340 19.315730 -0.074698 +1826 199 4 0 -2.255762 20.125803 1.185504 +1827 200 6 0 0.176360 18.576859 -11.340843 +1828 200 4 0 0.973470 18.653833 -11.875634 +1829 200 4 0 -0.251936 19.428753 -11.234458 +1830 201 6 0 17.647376 -13.725079 1.965824 +1831 201 4 0 17.003636 -13.021631 1.726278 +1832 201 4 0 17.566508 -13.822114 2.932054 +1833 202 6 0 22.517860 -11.753774 5.019726 +1834 202 4 0 23.053003 -11.763573 4.218425 +1835 202 4 0 22.141706 -12.627432 4.996598 +1836 203 6 0 11.399220 8.806142 17.642468 +1837 203 4 0 12.004399 8.181799 18.040253 +1838 203 4 0 12.065291 9.442856 17.324430 +1839 204 6 0 -22.707547 3.590100 -15.076457 +1840 204 4 0 -23.015628 3.384474 -15.944834 +1841 204 4 0 -22.136913 4.410365 -15.213029 +1842 205 6 0 26.828338 -4.765161 15.663973 +1843 205 4 0 26.832047 -4.257803 16.501858 +1844 205 4 0 26.708016 -5.703070 15.737740 +1845 206 6 0 22.946626 3.404021 -19.628978 +1846 206 4 0 23.362608 3.005393 -20.435220 +1847 206 4 0 23.702005 3.678843 -19.069388 +1848 207 6 0 14.618693 -13.688118 5.201099 +1849 207 4 0 14.145978 -13.778387 4.371412 +1850 207 4 0 14.286294 -12.904817 5.661369 +1851 208 6 0 20.255504 -4.724409 16.548573 +1852 208 4 0 21.059576 -4.438221 16.144026 +1853 208 4 0 20.147655 -4.094495 17.295647 +1854 209 6 0 17.946944 -13.347081 -18.020931 +1855 209 4 0 18.795624 -13.646112 -18.426334 +1856 209 4 0 17.332163 -14.081728 -18.189230 +1857 210 6 0 -21.344615 -17.675607 -16.681902 +1858 210 4 0 -21.267118 -18.651712 -16.747948 +1859 210 4 0 -21.006193 -17.563628 -15.786919 +1860 211 6 0 9.992481 17.630547 2.228887 +1861 211 4 0 10.766809 17.530717 1.634799 +1862 211 4 0 9.806200 16.754569 2.642189 +1863 212 6 0 24.337802 -5.112482 8.921340 +1864 212 4 0 24.079827 -4.328771 8.467115 +1865 212 4 0 24.773308 -4.851600 9.745303 +1866 213 6 0 14.392943 4.303039 -14.169804 +1867 213 4 0 15.354569 4.444986 -14.451391 +1868 213 4 0 13.827235 4.378323 -14.920116 +1869 214 6 0 13.209648 -16.451396 -6.580199 +1870 214 4 0 13.147603 -16.683269 -5.631990 +1871 214 4 0 12.554494 -16.916090 -7.141613 +1872 215 6 0 -11.258451 -8.728449 -17.504889 +1873 215 4 0 -10.630935 -8.841887 -16.742169 +1874 215 4 0 -10.880429 -7.995350 -17.987253 +1875 216 6 0 6.970091 -11.502288 7.137693 +1876 216 4 0 6.712825 -11.950891 7.959605 +1877 216 4 0 6.204207 -11.628119 6.619766 +1878 217 6 0 -10.553038 -2.495546 -20.126478 +1879 217 4 0 -11.112035 -2.806841 -20.861108 +1880 217 4 0 -10.112026 -1.746092 -20.545249 +1881 218 6 0 1.164804 16.447528 -16.932229 +1882 218 4 0 1.075245 17.028648 -17.728070 +1883 218 4 0 0.434843 16.567725 -16.272167 +1884 219 6 0 8.169876 -8.073942 10.663670 +1885 219 4 0 8.495588 -8.362155 9.831946 +1886 219 4 0 7.357988 -8.507192 10.922724 +1887 220 6 0 -9.618401 15.869865 -1.419048 +1888 220 4 0 -10.476694 15.771852 -1.849867 +1889 220 4 0 -9.747028 16.624761 -0.845144 +1890 221 6 0 -16.212359 4.292450 15.905633 +1891 221 4 0 -15.313397 4.006789 16.095169 +1892 221 4 0 -16.439629 4.732906 16.740073 +1893 222 6 0 21.084596 9.207592 -17.940912 +1894 222 4 0 20.944531 8.655711 -18.738875 +1895 222 4 0 20.567153 10.036337 -17.965821 +1896 223 6 0 6.469383 -5.770861 20.006921 +1897 223 4 0 5.993567 -6.597617 19.829705 +1898 223 4 0 7.305198 -6.017049 20.409842 +1899 224 6 0 17.758755 -18.446472 11.244435 +1900 224 4 0 16.943206 -18.055205 11.026410 +1901 224 4 0 17.620974 -18.589448 12.216673 +1902 225 6 0 2.239377 -2.639523 -18.372832 +1903 225 4 0 2.961435 -2.802836 -17.698014 +1904 225 4 0 2.575925 -2.857520 -19.307575 +1905 226 6 0 21.718884 10.313541 3.085849 +1906 226 4 0 21.842990 10.122072 2.194243 +1907 226 4 0 20.773441 10.408461 3.286860 +1908 227 6 0 13.337112 -4.261456 -15.095198 +1909 227 4 0 12.794211 -4.900007 -14.644470 +1910 227 4 0 14.199509 -4.728814 -15.315507 +1911 228 6 0 -9.310962 9.865254 8.826714 +1912 228 4 0 -9.669554 9.579689 7.984792 +1913 228 4 0 -9.735207 9.276237 9.445171 +1914 229 6 0 -15.178299 -9.566992 -12.324180 +1915 229 4 0 -15.367699 -10.462879 -12.630414 +1916 229 4 0 -14.646062 -9.588613 -11.528432 +1917 230 6 0 -15.859885 -9.750776 8.964734 +1918 230 4 0 -15.304809 -9.850444 8.125201 +1919 230 4 0 -16.789316 -9.705790 8.757985 +1920 231 6 0 -25.239908 11.310293 -1.569623 +1921 231 4 0 -25.920791 10.663431 -1.377427 +1922 231 4 0 -24.373594 10.784234 -1.594237 +1923 232 6 0 24.834518 19.880125 -12.068838 +1924 232 4 0 24.902598 19.037821 -11.641999 +1925 232 4 0 24.569359 20.529336 -11.363034 +1926 233 6 0 -4.910084 -12.441089 2.868321 +1927 233 4 0 -4.196304 -12.571833 3.512128 +1928 233 4 0 -4.472778 -12.489053 1.987214 +1929 234 6 0 26.315754 13.248691 -3.958358 +1930 234 4 0 27.266655 13.212107 -4.180929 +1931 234 4 0 26.465406 13.335958 -3.028348 +1932 235 6 0 24.328527 13.817013 16.149181 +1933 235 4 0 24.827781 14.030624 16.932358 +1934 235 4 0 24.179636 14.591188 15.603219 +1935 236 6 0 21.962373 -16.827624 8.004516 +1936 236 4 0 22.598048 -16.206072 7.580939 +1937 236 4 0 22.450590 -17.261823 8.740917 +1938 237 6 0 -4.825363 -16.614974 -12.877741 +1939 237 4 0 -4.014790 -16.722031 -13.388018 +1940 237 4 0 -4.509200 -15.980807 -12.256351 +1941 238 6 0 23.185997 6.818710 7.631707 +1942 238 4 0 24.005009 7.366044 7.817913 +1943 238 4 0 22.474898 7.499325 7.506791 +1944 239 6 0 6.937383 5.850956 20.832797 +1945 239 4 0 7.490164 6.651357 20.679338 +1946 239 4 0 6.435673 5.734889 20.013467 +1947 240 6 0 25.402656 -2.159701 -17.957744 +1948 240 4 0 25.621496 -3.084064 -17.880786 +1949 240 4 0 25.529344 -1.860574 -18.911595 +1950 241 6 0 10.846509 -11.228008 2.120758 +1951 241 4 0 9.913338 -11.028888 2.277705 +1952 241 4 0 11.049198 -10.691152 1.384887 +1953 242 6 0 23.084559 -1.383675 -1.852278 +1954 242 4 0 23.773226 -1.138388 -2.498419 +1955 242 4 0 22.268498 -0.905061 -2.136333 +1956 243 6 0 -25.783789 -13.543097 -4.342707 +1957 243 4 0 -26.780798 -13.463014 -4.533505 +1958 243 4 0 -25.653740 -14.383466 -3.955333 +1959 244 6 0 1.861632 12.171063 18.076482 +1960 244 4 0 2.556591 11.916600 18.652688 +1961 244 4 0 1.260792 12.537866 18.715290 +1962 245 6 0 -19.142537 14.105154 8.572032 +1963 245 4 0 -19.793181 13.415150 8.631452 +1964 245 4 0 -19.398536 14.384324 7.672644 +1965 246 6 0 9.479353 -2.096525 -4.320850 +1966 246 4 0 10.426570 -2.240688 -4.643403 +1967 246 4 0 9.264888 -1.350839 -4.888316 +1968 247 6 0 3.551422 -11.576062 19.271265 +1969 247 4 0 4.336383 -11.005500 19.220941 +1970 247 4 0 3.612389 -12.122719 20.093542 +1971 248 6 0 -18.654239 -9.535541 17.560019 +1972 248 4 0 -17.877715 -9.179943 17.854976 +1973 248 4 0 -18.494513 -10.119241 16.820922 +1974 249 6 0 22.066324 -17.399278 -0.499821 +1975 249 4 0 21.820234 -16.674838 0.099599 +1976 249 4 0 21.433067 -17.360481 -1.209273 +1977 250 6 0 -9.234082 15.614627 11.653381 +1978 250 4 0 -8.328429 15.947628 11.735875 +1979 250 4 0 -9.156328 14.657428 11.604942 +1980 251 6 0 22.367726 20.360775 16.024793 +1981 251 4 0 21.845316 20.438168 16.820627 +1982 251 4 0 23.011426 21.038841 16.155608 +1983 252 6 0 25.827187 -16.169219 18.903921 +1984 252 4 0 25.252638 -15.420311 18.639632 +1985 252 4 0 25.326971 -16.554629 19.621305 +1986 253 6 0 -19.668270 -7.707320 -8.620499 +1987 253 4 0 -19.491830 -6.794820 -8.636334 +1988 253 4 0 -20.495353 -7.784914 -8.110009 +1989 254 6 0 -15.712732 17.116061 17.387342 +1990 254 4 0 -14.998205 17.679818 17.573935 +1991 254 4 0 -16.301994 17.627283 16.828989 +1992 255 6 0 0.390078 14.938221 -20.122911 +1993 255 4 0 -0.551277 14.873494 -20.329275 +1994 255 4 0 0.539841 14.256395 -19.453229 +1995 256 6 0 15.977716 -18.683555 17.772786 +1996 256 4 0 15.456606 -18.921580 16.979089 +1997 256 4 0 16.280568 -17.751033 17.661557 +1998 257 6 0 5.239306 11.123091 17.557541 +1999 257 4 0 4.918202 10.242467 17.653834 +2000 257 4 0 6.086403 10.952070 18.021365 +2001 258 6 0 9.328850 -5.185156 13.272163 +2002 258 4 0 9.601653 -6.131901 13.229534 +2003 258 4 0 9.762360 -4.740121 12.531719 +2004 259 6 0 25.477790 -8.345165 0.584885 +2005 259 4 0 25.598427 -7.389198 0.879361 +2006 259 4 0 26.086040 -8.798249 1.118095 +2007 260 6 0 17.311830 -17.527015 -10.578123 +2008 260 4 0 17.719447 -16.732289 -10.965110 +2009 260 4 0 16.654082 -17.252150 -9.925765 +2010 261 6 0 -4.429164 -9.201790 -14.116626 +2011 261 4 0 -4.244658 -8.992311 -13.212737 +2012 261 4 0 -5.336375 -8.936542 -14.234036 +2013 262 6 0 2.267339 -4.673980 16.117302 +2014 262 4 0 3.232259 -4.591281 16.113612 +2015 262 4 0 1.900019 -4.413838 16.958419 +2016 263 6 0 25.781004 -8.714690 8.400591 +2017 263 4 0 24.912042 -8.751175 8.867313 +2018 263 4 0 25.752072 -9.508607 7.845086 +2019 264 6 0 24.780338 7.832712 -16.490027 +2020 264 4 0 25.553470 8.297242 -16.909830 +2021 264 4 0 24.349053 7.422109 -17.205903 +2022 265 6 0 -10.973211 -14.579748 -20.349565 +2023 265 4 0 -11.809581 -14.181319 -20.199526 +2024 265 4 0 -11.271798 -15.372634 -20.833354 +2025 266 6 0 20.831402 -9.834964 6.727716 +2026 266 4 0 21.613032 -10.442134 6.754402 +2027 266 4 0 20.647604 -9.731183 7.657599 +2028 267 6 0 0.619789 -15.810628 3.994148 +2029 267 4 0 0.887335 -16.417198 3.309856 +2030 267 4 0 1.249715 -15.910162 4.713083 +2031 268 6 0 23.689965 0.227417 -19.055575 +2032 268 4 0 23.390627 1.115135 -18.834814 +2033 268 4 0 24.618115 0.214091 -18.686279 +2034 269 6 0 -19.356143 -14.966182 6.464534 +2035 269 4 0 -18.731353 -14.875616 7.195912 +2036 269 4 0 -19.299498 -14.034705 6.108709 +2037 270 6 0 -4.810820 7.093213 18.692708 +2038 270 4 0 -4.214506 7.397678 17.991691 +2039 270 4 0 -5.304442 7.897279 18.897729 +2040 271 6 0 12.472494 14.825856 12.199392 +2041 271 4 0 11.666376 14.488038 12.655650 +2042 271 4 0 12.151762 15.361991 11.488854 +2043 272 6 0 -2.525590 -19.553036 -5.583420 +2044 272 4 0 -3.387077 -20.012041 -5.603558 +2045 272 4 0 -1.916602 -19.904101 -6.266561 +2046 273 6 0 -13.215935 11.484331 -2.785220 +2047 273 4 0 -12.887174 11.682417 -1.972234 +2048 273 4 0 -12.509591 11.786661 -3.422263 +2049 274 6 0 13.801640 -19.398163 -2.800474 +2050 274 4 0 12.819741 -19.619737 -2.646754 +2051 274 4 0 13.897982 -19.592042 -3.772199 +2052 275 6 0 -26.233001 19.527836 -20.067788 +2053 275 4 0 -25.451886 18.897692 -20.194468 +2054 275 4 0 -26.399315 19.934622 -20.917526 +2055 276 6 0 8.349896 -20.273103 -5.512912 +2056 276 4 0 8.674030 -19.375363 -5.549945 +2057 276 4 0 7.700037 -20.342277 -4.787842 +2058 277 6 0 -15.037355 -17.935516 15.211469 +2059 277 4 0 -14.146082 -18.339695 15.389947 +2060 277 4 0 -15.202223 -17.984699 14.215392 +2061 278 6 0 8.152699 -3.220333 -19.381684 +2062 278 4 0 7.762730 -2.473688 -19.830286 +2063 278 4 0 8.435795 -2.793242 -18.522747 +2064 279 6 0 10.849575 20.172811 -12.945894 +2065 279 4 0 9.989543 19.760584 -12.890237 +2066 279 4 0 10.974253 20.477018 -13.831243 +2067 280 6 0 -18.094216 -18.088456 -0.091619 +2068 280 4 0 -17.380813 -18.647373 0.106032 +2069 280 4 0 -18.936664 -18.511988 -0.052421 +2070 281 6 0 23.784383 -1.234714 -8.545459 +2071 281 4 0 23.004694 -0.954068 -8.088149 +2072 281 4 0 23.886388 -2.202962 -8.397824 +2073 282 6 0 4.670856 19.296845 -6.507264 +2074 282 4 0 5.525567 19.132893 -6.020467 +2075 282 4 0 4.474979 18.536310 -7.056492 +2076 283 6 0 9.453183 -16.128245 10.894262 +2077 283 4 0 9.172486 -17.052303 10.804233 +2078 283 4 0 8.694890 -15.636054 10.554101 +2079 284 6 0 27.285633 -19.419687 13.608447 +2080 284 4 0 27.147712 -20.155434 14.224268 +2081 284 4 0 27.432376 -19.841205 12.735609 +2082 285 6 0 -13.953143 18.767914 -18.628277 +2083 285 4 0 -14.509541 18.177509 -19.151919 +2084 285 4 0 -14.459773 19.481659 -18.276757 +2085 286 6 0 -8.503297 -13.558947 20.139036 +2086 286 4 0 -9.241112 -13.897460 20.705789 +2087 286 4 0 -7.777412 -13.533354 20.859006 +2088 287 6 0 14.842167 15.398345 -11.842827 +2089 287 4 0 14.711447 15.430309 -12.769279 +2090 287 4 0 14.422321 14.556870 -11.583006 +2091 288 6 0 23.515535 -17.148566 -6.707313 +2092 288 4 0 22.824916 -16.517939 -6.421660 +2093 288 4 0 24.263955 -17.052636 -6.082683 +2094 289 6 0 19.904467 -17.703379 -13.473161 +2095 289 4 0 20.119864 -16.820025 -13.921272 +2096 289 4 0 18.948028 -17.662123 -13.295016 +2097 290 6 0 -9.019729 7.630624 20.233912 +2098 290 4 0 -8.958585 7.872806 21.205680 +2099 290 4 0 -8.777610 8.395080 19.734355 +2100 291 6 0 -16.953402 12.468570 8.282984 +2101 291 4 0 -17.680339 13.160784 8.478943 +2102 291 4 0 -17.500933 11.923064 7.633961 +2103 292 6 0 -8.054795 18.180983 8.459840 +2104 292 4 0 -8.807469 17.559774 8.499933 +2105 292 4 0 -7.598916 17.959389 7.659706 +2106 293 6 0 10.859202 13.972660 9.371520 +2107 293 4 0 10.330904 14.662590 8.917941 +2108 293 4 0 11.760678 13.901317 8.995461 +2109 294 6 0 -20.599796 5.434907 14.082586 +2110 294 4 0 -19.823357 5.807091 13.669543 +2111 294 4 0 -20.650272 4.587948 13.614754 +2112 295 6 0 0.190160 0.223418 -18.957409 +2113 295 4 0 0.213080 -0.260216 -19.803123 +2114 295 4 0 -0.108015 1.088627 -19.162666 +2115 296 6 0 -14.055059 -11.353804 -4.019394 +2116 296 4 0 -14.940567 -11.063742 -3.674139 +2117 296 4 0 -13.870222 -12.125592 -3.430663 +2118 297 6 0 16.635849 17.308753 12.681784 +2119 297 4 0 16.261670 16.470264 12.423079 +2120 297 4 0 17.008841 17.677123 11.849363 +2121 298 6 0 -25.308969 5.432856 -17.149527 +2122 298 4 0 -24.655164 5.918154 -17.671798 +2123 298 4 0 -24.982451 5.555957 -16.246756 +2124 299 6 0 -5.099798 0.287541 -14.704188 +2125 299 4 0 -5.138931 0.519591 -15.635776 +2126 299 4 0 -4.195405 -0.084328 -14.624163 +2127 300 6 0 -23.748764 -10.173408 15.212702 +2128 300 4 0 -23.345980 -11.023651 15.356645 +2129 300 4 0 -22.994745 -9.539993 15.112815 +2130 301 6 0 -19.199669 -17.758897 16.946421 +2131 301 4 0 -19.316903 -16.926776 16.445483 +2132 301 4 0 -18.281115 -18.078783 16.752689 +2133 302 6 0 24.275104 4.639677 -5.172613 +2134 302 4 0 24.760810 5.226861 -4.613774 +2135 302 4 0 24.701632 4.684738 -6.052735 +2136 303 6 0 17.563599 12.903092 3.658695 +2137 303 4 0 17.685848 13.560550 2.940588 +2138 303 4 0 16.898391 13.306778 4.183635 +2139 304 6 0 4.174461 14.293392 18.270873 +2140 304 4 0 4.252009 13.308189 18.184247 +2141 304 4 0 3.284820 14.507614 18.560426 +2142 305 6 0 19.179266 -5.054347 -19.519249 +2143 305 4 0 18.780260 -5.604062 -18.845970 +2144 305 4 0 19.534147 -5.684633 -20.141388 +2145 306 6 0 15.658994 11.957779 13.199900 +2146 306 4 0 15.623319 12.838749 12.752640 +2147 306 4 0 16.531973 11.890366 13.660327 +2148 307 6 0 24.758272 -19.997077 5.366209 +2149 307 4 0 24.975628 -20.215262 6.282332 +2150 307 4 0 23.761106 -19.988430 5.431807 +2151 308 6 0 -2.249027 18.570837 -6.683241 +2152 308 4 0 -2.430859 18.100958 -7.499568 +2153 308 4 0 -2.994327 18.644727 -6.092295 +2154 309 6 0 3.560378 -14.631233 -16.617924 +2155 309 4 0 3.964695 -14.691511 -15.761000 +2156 309 4 0 3.979389 -13.913756 -17.067597 +2157 310 6 0 -20.545154 -8.912553 -11.230039 +2158 310 4 0 -21.471069 -9.085454 -11.070560 +2159 310 4 0 -20.109583 -8.288894 -10.586743 +2160 311 6 0 -19.728929 -18.157363 9.832477 +2161 311 4 0 -20.527618 -17.995705 9.320962 +2162 311 4 0 -19.366046 -18.994557 9.552804 +2163 312 6 0 -12.565736 15.723300 8.977635 +2164 312 4 0 -13.331978 15.327968 8.600724 +2165 312 4 0 -12.885953 15.953376 9.855856 +2166 313 6 0 7.768656 -13.056656 -8.955241 +2167 313 4 0 8.048624 -13.789739 -8.425150 +2168 313 4 0 8.500788 -12.860524 -9.542256 +2169 314 6 0 17.695317 -0.658526 -5.443674 +2170 314 4 0 16.888949 -0.180431 -5.230393 +2171 314 4 0 17.868907 -0.568768 -6.336008 +2172 315 6 0 -26.474265 -17.668366 15.551800 +2173 315 4 0 -25.973432 -16.911585 15.255881 +2174 315 4 0 -26.867392 -18.124201 14.764520 +2175 316 6 0 20.955024 16.299890 1.156790 +2176 316 4 0 20.921523 15.384753 1.335509 +2177 316 4 0 20.079452 16.568627 1.085050 +2178 317 6 0 -23.821616 -1.174086 5.308601 +2179 317 4 0 -24.669920 -1.473611 4.967755 +2180 317 4 0 -23.878862 -0.261519 5.469448 +2181 318 6 0 -25.063965 -17.135593 -5.451522 +2182 318 4 0 -24.564833 -16.443850 -5.938694 +2183 318 4 0 -25.016214 -17.933665 -5.953179 +2184 319 6 0 8.668628 -10.867057 3.901078 +2185 319 4 0 7.746163 -11.110803 3.959883 +2186 319 4 0 8.752868 -10.022287 4.307352 +2187 320 6 0 5.527084 -9.208555 11.411321 +2188 320 4 0 4.725607 -8.751662 11.714973 +2189 320 4 0 5.164735 -10.130404 11.316322 +2190 321 6 0 -9.337532 -6.457757 20.443267 +2191 321 4 0 -9.836709 -6.506988 19.607051 +2192 321 4 0 -8.808476 -7.295450 20.450087 +2193 322 6 0 19.513522 2.780765 9.780761 +2194 322 4 0 19.329574 3.702885 9.602934 +2195 322 4 0 18.756331 2.266956 9.355945 +2196 323 6 0 -0.037870 9.082570 10.914997 +2197 323 4 0 -0.144923 8.896093 11.865591 +2198 323 4 0 0.659909 9.734037 10.785946 +2199 324 6 0 21.027998 -15.348739 14.790857 +2200 324 4 0 21.254465 -15.801776 13.888722 +2201 324 4 0 20.075738 -15.400354 14.845656 +2202 325 6 0 14.156515 -11.391327 -14.361896 +2203 325 4 0 14.547773 -11.645291 -13.478079 +2204 325 4 0 14.944302 -11.067054 -14.899771 +2205 326 6 0 -25.175320 17.336673 -10.823444 +2206 326 4 0 -24.334636 17.464575 -11.235937 +2207 326 4 0 -25.742033 18.106292 -10.995823 +2208 327 6 0 -4.110604 17.298456 -14.084863 +2209 327 4 0 -5.063030 17.631527 -14.014860 +2210 327 4 0 -3.534872 17.849349 -13.549744 +2211 328 6 0 -8.725501 -4.824788 13.985429 +2212 328 4 0 -8.885224 -4.493817 14.844915 +2213 328 4 0 -9.307957 -4.341036 13.364528 +2214 329 6 0 -16.804142 -4.642352 -8.769233 +2215 329 4 0 -16.450670 -4.499749 -7.869595 +2216 329 4 0 -16.368056 -3.963859 -9.273107 +2217 330 6 0 -13.154274 13.347332 -10.792162 +2218 330 4 0 -13.404917 13.942330 -10.034598 +2219 330 4 0 -12.589084 12.641097 -10.473229 +2220 331 6 0 -8.087285 12.645852 17.838668 +2221 331 4 0 -8.371003 13.597239 17.804934 +2222 331 4 0 -8.469236 12.290110 16.988633 +2223 332 6 0 -22.931798 10.095495 10.652715 +2224 332 4 0 -23.213802 9.766315 11.531742 +2225 332 4 0 -23.320207 11.046413 10.700380 +2226 333 6 0 -20.983751 11.377312 6.751864 +2227 333 4 0 -21.503099 10.599928 6.692621 +2228 333 4 0 -21.162587 11.703483 7.660694 +2229 334 6 0 -9.661190 -11.046578 19.483449 +2230 334 4 0 -9.724620 -11.203957 20.428241 +2231 334 4 0 -9.182029 -11.809683 19.119545 +2232 335 6 0 20.353500 0.575918 7.152755 +2233 335 4 0 20.303576 0.620770 8.117649 +2234 335 4 0 20.337320 -0.339163 6.903512 +2235 336 6 0 15.990143 -2.457675 4.143017 +2236 336 4 0 15.489807 -1.953955 3.480334 +2237 336 4 0 15.653499 -2.040453 4.954556 +2238 337 6 0 -2.567783 16.482281 -16.807948 +2239 337 4 0 -3.050946 16.892783 -16.078496 +2240 337 4 0 -2.535318 17.087619 -17.572948 +2241 338 6 0 -16.459463 12.994478 3.247220 +2242 338 4 0 -16.263104 13.723100 3.963882 +2243 338 4 0 -16.915538 12.273221 3.618885 +2244 339 6 0 -19.849611 -12.213163 -10.741659 +2245 339 4 0 -19.664050 -11.750480 -11.517833 +2246 339 4 0 -20.220973 -11.559473 -10.070660 +2247 340 6 0 9.529408 -8.147204 4.860752 +2248 340 4 0 9.247691 -7.588893 5.626073 +2249 340 4 0 10.362750 -8.519549 5.100951 +2250 341 6 0 21.538384 -19.843213 20.537686 +2251 341 4 0 20.838857 -19.226662 20.298246 +2252 341 4 0 21.322950 -20.195215 21.445033 +2253 342 6 0 -17.414751 11.192172 -0.613866 +2254 342 4 0 -16.961551 11.804357 -1.153593 +2255 342 4 0 -16.725569 10.585952 -0.366735 +2256 343 6 0 -21.091905 1.428060 -3.164120 +2257 343 4 0 -21.397983 0.608166 -3.585164 +2258 343 4 0 -21.036566 1.285518 -2.209763 +2259 344 6 0 4.570809 -15.227797 -13.905090 +2260 344 4 0 5.091400 -16.090349 -13.835376 +2261 344 4 0 4.857834 -14.567263 -13.304845 +2262 345 6 0 10.258640 0.903759 11.623534 +2263 345 4 0 10.598017 1.120991 12.514742 +2264 345 4 0 10.521679 1.552470 11.006853 +2265 346 6 0 17.642778 19.808652 2.346246 +2266 346 4 0 17.869355 20.445525 1.653123 +2267 346 4 0 18.518553 19.467904 2.662406 +2268 347 6 0 -22.563090 -16.244370 16.474521 +2269 347 4 0 -22.037402 -15.816362 17.175370 +2270 347 4 0 -22.163193 -17.008155 16.111897 +2271 348 6 0 -21.737447 10.632642 0.323883 +2272 348 4 0 -22.138870 9.972645 -0.310600 +2273 348 4 0 -20.878663 10.242561 0.662313 +2274 349 6 0 4.943953 4.514136 10.142833 +2275 349 4 0 4.093975 4.955485 10.181030 +2276 349 4 0 5.290181 4.560969 11.077254 +2277 350 6 0 27.098096 16.972617 9.553607 +2278 350 4 0 27.164532 17.549674 10.320006 +2279 350 4 0 26.222145 17.230319 9.158216 +2280 351 6 0 9.975471 10.519219 19.375075 +2281 351 4 0 10.438521 9.921274 18.809666 +2282 351 4 0 10.113621 10.195006 20.328269 +2283 352 6 0 19.572560 8.531305 -14.059063 +2284 352 4 0 20.062311 8.733262 -13.213496 +2285 352 4 0 20.153062 7.889577 -14.538183 +2286 353 6 0 -7.918488 -2.954663 -18.780336 +2287 353 4 0 -7.314540 -2.910798 -19.514402 +2288 353 4 0 -8.797924 -3.116600 -19.166228 +2289 354 6 0 19.686374 -16.545236 11.269807 +2290 354 4 0 18.989129 -17.260241 11.377153 +2291 354 4 0 19.219253 -15.710481 11.534976 +2292 355 6 0 27.391573 13.462198 15.739536 +2293 355 4 0 26.622656 13.814429 16.131734 +2294 355 4 0 28.086271 13.184682 16.372753 +2295 356 6 0 18.671829 14.132646 1.432787 +2296 356 4 0 18.377115 15.035385 1.296775 +2297 356 4 0 19.190360 13.851325 0.615983 +2298 357 6 0 -12.681771 -19.875375 -9.428073 +2299 357 4 0 -12.883609 -20.344329 -8.608964 +2300 357 4 0 -13.567320 -19.451635 -9.646126 +2301 358 6 0 10.029899 9.448526 2.506329 +2302 358 4 0 9.228082 9.803143 2.872633 +2303 358 4 0 10.370666 8.711255 3.072050 +2304 359 6 0 6.829895 1.451627 -19.901465 +2305 359 4 0 5.933644 1.521889 -20.328666 +2306 359 4 0 6.997933 0.508973 -20.108952 +2307 360 6 0 11.280235 -14.880225 18.973288 +2308 360 4 0 11.853282 -14.806884 19.759711 +2309 360 4 0 11.206610 -13.922929 18.647648 +2310 361 6 0 -13.509311 20.508361 -14.696662 +2311 361 4 0 -13.366236 21.153458 -13.979706 +2312 361 4 0 -13.642549 19.724179 -14.192639 +2313 362 6 0 15.445671 -17.794973 -8.479139 +2314 362 4 0 14.669400 -17.783629 -7.901271 +2315 362 4 0 15.605108 -18.746647 -8.547881 +2316 363 6 0 -18.852558 16.377330 10.008262 +2317 363 4 0 -18.954566 15.472318 9.697097 +2318 363 4 0 -18.836824 16.305839 10.975588 +2319 364 6 0 -3.265075 16.259228 2.098989 +2320 364 4 0 -3.687496 16.647682 2.840607 +2321 364 4 0 -3.231168 15.327934 2.400445 +2322 365 6 0 23.408970 8.557256 -2.138126 +2323 365 4 0 23.726381 8.828223 -3.046334 +2324 365 4 0 24.153951 8.006209 -1.806696 +2325 366 6 0 -18.228938 -7.461297 -20.804424 +2326 366 4 0 -17.795687 -7.325321 -21.656583 +2327 366 4 0 -19.188295 -7.558977 -20.991723 +2328 367 6 0 14.146043 8.886880 -14.615085 +2329 367 4 0 13.553393 8.171127 -14.600739 +2330 367 4 0 15.003303 8.599303 -14.311172 +2331 368 6 0 20.665164 -4.419654 -16.715421 +2332 368 4 0 20.745422 -5.254288 -17.245683 +2333 368 4 0 20.538188 -3.785743 -17.440686 +2334 369 6 0 -26.165001 -17.430791 -11.871737 +2335 369 4 0 -26.769662 -17.569088 -12.614295 +2336 369 4 0 -25.372303 -17.816712 -12.251152 +2337 370 6 0 8.380243 12.002311 -18.225092 +2338 370 4 0 9.331509 12.039099 -17.900481 +2339 370 4 0 7.935426 11.441291 -17.531137 +2340 371 6 0 16.095732 -15.248679 -18.961804 +2341 371 4 0 16.404115 -16.023436 -19.441838 +2342 371 4 0 15.279718 -15.501183 -18.509138 +2343 372 6 0 22.345963 -0.521889 9.487232 +2344 372 4 0 22.570555 0.299269 9.062706 +2345 372 4 0 21.500534 -0.394595 9.878388 +2346 373 6 0 -5.612444 19.185073 -9.536350 +2347 373 4 0 -5.038468 18.530538 -9.043403 +2348 373 4 0 -6.014867 19.664271 -8.828529 +2349 374 6 0 -25.317965 -13.476019 -10.680751 +2350 374 4 0 -24.422815 -13.795959 -10.857483 +2351 374 4 0 -25.587407 -14.286723 -10.139795 +2352 375 6 0 5.097575 -2.791870 -18.340648 +2353 375 4 0 5.426002 -3.124971 -17.421700 +2354 375 4 0 5.173769 -1.845992 -18.214725 +2355 376 6 0 -12.050426 13.594034 -0.308748 +2356 376 4 0 -12.143354 14.332220 -0.865135 +2357 376 4 0 -12.835416 13.379684 0.170780 +2358 377 6 0 21.220086 12.431770 7.373850 +2359 377 4 0 20.289621 12.356271 7.355050 +2360 377 4 0 21.528409 11.600369 6.969319 +2361 378 6 0 -11.849558 -15.011079 -4.217755 +2362 378 4 0 -12.535045 -15.564610 -4.601476 +2363 378 4 0 -11.261594 -15.726054 -3.732481 +2364 379 6 0 19.540600 10.648547 -0.222993 +2365 379 4 0 19.073765 10.676651 0.596923 +2366 379 4 0 19.853650 11.516176 -0.351029 +2367 380 6 0 -1.367659 10.060973 3.255905 +2368 380 4 0 -0.787645 10.846481 3.221548 +2369 380 4 0 -0.921325 9.404127 2.683633 +2370 381 6 0 17.574245 20.192556 -13.486878 +2371 381 4 0 18.041333 19.630746 -14.072375 +2372 381 4 0 18.127340 20.293838 -12.705179 +2373 382 6 0 -18.105957 7.325844 1.685035 +2374 382 4 0 -17.284929 7.597738 2.015915 +2375 382 4 0 -18.515197 8.193099 1.440712 +2376 383 6 0 -25.771851 -0.494052 1.833459 +2377 383 4 0 -26.562791 0.014660 2.156519 +2378 383 4 0 -25.800109 -0.615443 0.880744 +2379 384 6 0 13.515684 3.091718 8.129575 +2380 384 4 0 12.824035 3.780462 8.011639 +2381 384 4 0 13.855067 3.149101 9.026041 +2382 385 6 0 15.024255 -12.331971 18.507086 +2383 385 4 0 14.688886 -12.986046 17.868523 +2384 385 4 0 14.285850 -11.759175 18.796860 +2385 386 6 0 10.503062 -17.208661 -17.537094 +2386 386 4 0 10.869560 -17.224545 -18.470986 +2387 386 4 0 10.144441 -18.040582 -17.343990 +2388 387 6 0 2.330431 13.849933 -16.758821 +2389 387 4 0 1.519885 13.548197 -17.169816 +2390 387 4 0 2.257199 14.793756 -16.760513 +2391 388 6 0 -23.129172 -9.148548 -12.092521 +2392 388 4 0 -24.075243 -8.995756 -12.000743 +2393 388 4 0 -23.086180 -10.039746 -12.445685 +2394 389 6 0 -17.448662 -1.079141 -7.931513 +2395 389 4 0 -17.738453 -1.885709 -7.374659 +2396 389 4 0 -18.172042 -1.099635 -8.625421 +2397 390 6 0 24.048570 -3.763661 -7.564125 +2398 390 4 0 24.193240 -3.884883 -6.642519 +2399 390 4 0 24.456227 -4.566888 -7.925689 +2400 391 6 0 -17.808703 -19.337398 7.373130 +2401 391 4 0 -17.303175 -20.173651 7.501985 +2402 391 4 0 -17.692612 -19.135904 6.461238 +2403 392 6 0 4.319079 -18.666468 -6.315988 +2404 392 4 0 4.318654 -19.531271 -6.749054 +2405 392 4 0 3.377567 -18.420225 -6.140192 +2406 393 6 0 15.744362 14.892988 2.660633 +2407 393 4 0 15.944482 15.856708 2.714939 +2408 393 4 0 15.301384 14.836913 1.848608 +2409 394 6 0 -6.829329 -18.727707 2.030136 +2410 394 4 0 -6.415578 -18.452019 2.842593 +2411 394 4 0 -6.067476 -19.005491 1.466821 +2412 395 6 0 24.121188 19.977112 -20.354495 +2413 395 4 0 24.224055 19.319758 -19.652345 +2414 395 4 0 24.762727 19.635175 -20.939363 +2415 396 6 0 10.579259 -12.534608 5.151755 +2416 396 4 0 9.930043 -12.025918 4.646940 +2417 396 4 0 11.359927 -12.071097 4.861131 +2418 397 6 0 5.967673 -14.216687 -10.676351 +2419 397 4 0 6.631855 -14.774737 -11.170158 +2420 397 4 0 6.490580 -13.637897 -10.118514 +2421 398 6 0 18.539687 -16.102929 15.331204 +2422 398 4 0 18.327655 -16.200138 16.203787 +2423 398 4 0 17.897003 -15.568195 14.864351 +2424 399 6 0 -2.895055 -4.676531 11.113797 +2425 399 4 0 -2.434824 -5.435723 10.710060 +2426 399 4 0 -2.231401 -4.035506 11.395814 +2427 400 6 0 -8.133832 14.629593 7.309404 +2428 400 4 0 -8.851831 15.090624 7.871798 +2429 400 4 0 -7.946895 13.906109 7.942402 +2430 401 6 0 22.250798 0.698906 -0.231699 +2431 401 4 0 22.200775 1.664146 -0.197509 +2432 401 4 0 22.955911 0.389699 -0.887067 +2433 402 6 0 4.057613 14.734523 9.271521 +2434 402 4 0 3.560432 15.591515 9.153949 +2435 402 4 0 4.938114 14.882755 8.921185 +2436 403 6 0 -17.698257 12.666615 -4.894250 +2437 403 4 0 -17.252884 12.676027 -4.012690 +2438 403 4 0 -18.619276 12.371224 -4.622833 +2439 404 6 0 26.668158 -12.819700 -1.311515 +2440 404 4 0 27.032009 -13.646800 -1.097954 +2441 404 4 0 26.646890 -12.850693 -2.254784 +2442 405 6 0 7.224554 13.850996 3.318452 +2443 405 4 0 8.019795 14.275937 3.600876 +2444 405 4 0 7.668540 12.980654 3.041459 +2445 406 6 0 8.952709 -7.047293 -13.075849 +2446 406 4 0 9.898167 -6.904505 -13.302591 +2447 406 4 0 8.562667 -6.214154 -12.992709 +2448 407 6 0 -17.814401 -1.840934 -1.803929 +2449 407 4 0 -18.744975 -1.741200 -1.902642 +2450 407 4 0 -17.699335 -2.395812 -1.018915 +2451 408 6 0 -24.621095 6.164997 -14.673611 +2452 408 4 0 -24.877382 5.755063 -13.785112 +2453 408 4 0 -23.950276 6.830635 -14.339769 +2454 409 6 0 10.479140 -19.025039 18.297194 +2455 409 4 0 11.349364 -18.876899 18.653004 +2456 409 4 0 10.644550 -19.606803 17.504887 +2457 410 6 0 -19.101403 14.252398 -1.786055 +2458 410 4 0 -19.573879 14.657593 -2.525389 +2459 410 4 0 -19.587903 13.601901 -1.323620 +2460 411 6 0 6.717226 1.088539 17.700070 +2461 411 4 0 6.231555 1.199419 18.516697 +2462 411 4 0 6.881490 0.099135 17.787770 +2463 412 6 0 -13.643189 -7.863866 -8.730575 +2464 412 4 0 -14.517866 -7.638837 -9.023604 +2465 412 4 0 -13.154332 -7.346815 -9.390510 +2466 413 6 0 -17.730487 0.990816 -0.622980 +2467 413 4 0 -17.303015 0.205330 -0.935730 +2468 413 4 0 -17.531444 1.017418 0.308170 +2469 414 6 0 25.260176 -10.957318 6.206094 +2470 414 4 0 25.876991 -10.477352 5.676397 +2471 414 4 0 24.475935 -10.963099 5.603334 +2472 415 6 0 14.205628 -17.408033 -13.601399 +2473 415 4 0 14.188193 -18.247713 -13.204445 +2474 415 4 0 13.713279 -17.625825 -14.405922 +2475 416 6 0 -20.784853 -15.686238 -5.898849 +2476 416 4 0 -19.875611 -15.547599 -5.727799 +2477 416 4 0 -21.245430 -14.929289 -5.375604 +2478 417 6 0 -22.633197 8.330983 -13.909999 +2479 417 4 0 -22.233520 9.245054 -13.847024 +2480 417 4 0 -21.843881 7.942242 -14.256165 +2481 418 6 0 11.786714 0.286536 -14.937634 +2482 418 4 0 11.786532 -0.671475 -15.215390 +2483 418 4 0 11.605445 0.272418 -13.981805 +2484 419 6 0 1.681240 0.254113 10.330852 +2485 419 4 0 1.597166 -0.618385 10.733271 +2486 419 4 0 1.413887 0.849687 11.007136 +2487 420 6 0 6.751727 13.837704 8.238736 +2488 420 4 0 6.439245 13.979946 7.299037 +2489 420 4 0 7.165300 14.697405 8.431164 +2490 421 6 0 22.234756 20.556412 6.164713 +2491 421 4 0 21.672715 21.351790 6.258812 +2492 421 4 0 21.702890 19.818097 6.555926 +2493 422 6 0 17.385018 20.449668 10.876882 +2494 422 4 0 16.551469 20.156010 10.407413 +2495 422 4 0 17.440995 21.384757 10.538556 +2496 423 6 0 17.700641 4.527370 19.573010 +2497 423 4 0 17.031995 4.431285 20.256942 +2498 423 4 0 17.481318 3.724034 19.023628 +2499 424 6 0 0.483339 18.111382 -1.823860 +2500 424 4 0 0.218803 18.655109 -1.106869 +2501 424 4 0 1.294713 18.496788 -2.211913 +2502 425 6 0 22.943918 -17.096855 -14.079609 +2503 425 4 0 22.830905 -16.325512 -14.742916 +2504 425 4 0 22.793828 -16.695124 -13.249381 +2505 426 6 0 -12.197414 -2.755310 -15.143763 +2506 426 4 0 -11.972492 -3.409760 -15.785801 +2507 426 4 0 -11.687560 -1.995802 -15.449188 +2508 427 6 0 26.233813 3.059744 -20.109192 +2509 427 4 0 25.634066 3.752709 -19.758728 +2510 427 4 0 26.841050 3.505495 -20.746283 +2511 428 6 0 -0.398685 9.886291 -12.320899 +2512 428 4 0 -0.971500 9.110158 -12.271110 +2513 428 4 0 -0.140227 10.055684 -11.384852 +2514 429 6 0 24.766172 -8.159537 20.532359 +2515 429 4 0 24.676407 -7.239089 20.840721 +2516 429 4 0 23.932220 -8.459730 20.138818 +2517 430 6 0 -13.286555 16.304911 0.900630 +2518 430 4 0 -13.716595 15.953327 1.640887 +2519 430 4 0 -12.366691 16.365858 1.124146 +2520 431 6 0 23.399832 -13.989313 -14.426821 +2521 431 4 0 22.828210 -13.569339 -13.765880 +2522 431 4 0 23.255649 -13.414985 -15.246789 +2523 432 6 0 -22.204092 -4.611638 18.736383 +2524 432 4 0 -21.249902 -4.938147 18.770328 +2525 432 4 0 -22.211606 -3.716829 18.428273 +2526 433 6 0 21.224851 -14.221140 4.789172 +2527 433 4 0 20.596044 -14.495409 5.464993 +2528 433 4 0 21.036876 -14.781346 3.969428 +2529 434 6 0 -0.044311 17.960476 1.830489 +2530 434 4 0 -0.313520 17.147157 1.446425 +2531 434 4 0 -0.796207 18.542831 1.866711 +2532 435 6 0 -18.246500 10.701990 6.592891 +2533 435 4 0 -19.216406 10.992455 6.669125 +2534 435 4 0 -18.267435 9.771442 6.876019 +2535 436 6 0 -0.694143 4.494214 14.021020 +2536 436 4 0 -1.277964 4.997681 13.392435 +2537 436 4 0 -1.155981 4.663647 14.857205 +2538 437 6 0 22.107052 12.819546 -9.903327 +2539 437 4 0 21.296704 13.306649 -9.951121 +2540 437 4 0 22.688713 13.295428 -10.537192 +2541 438 6 0 15.302055 -5.253465 4.034438 +2542 438 4 0 15.326181 -4.291521 3.882146 +2543 438 4 0 16.042293 -5.540500 3.526531 +2544 439 6 0 23.950953 1.271229 5.710913 +2545 439 4 0 23.173495 0.716989 5.765239 +2546 439 4 0 24.051944 1.770274 6.552925 +2547 440 6 0 14.279151 12.647971 15.806599 +2548 440 4 0 14.591090 12.573140 14.893038 +2549 440 4 0 13.381765 12.300162 15.960467 +2550 441 6 0 15.038801 -1.661905 6.589100 +2551 441 4 0 15.892587 -1.551660 6.975739 +2552 441 4 0 14.462182 -0.875051 6.734929 +2553 442 6 0 -6.429505 -9.279231 12.087220 +2554 442 4 0 -6.701830 -10.093703 11.622225 +2555 442 4 0 -5.612815 -9.032770 11.586921 +2556 443 6 0 11.290924 -10.372276 7.217133 +2557 443 4 0 10.622389 -10.955150 6.788259 +2558 443 4 0 11.616275 -9.796597 6.503882 +2559 444 6 0 -24.866907 -13.913179 10.222650 +2560 444 4 0 -24.271979 -13.182736 9.950447 +2561 444 4 0 -25.017302 -14.420326 9.408453 +2562 445 6 0 -27.314146 -19.793576 17.380891 +2563 445 4 0 -27.699149 -20.386657 16.714229 +2564 445 4 0 -26.959051 -19.085769 16.826343 +2565 446 6 0 12.965414 4.595141 18.162499 +2566 446 4 0 13.458928 3.797998 18.472673 +2567 446 4 0 12.462784 4.369395 17.349650 +2568 447 6 0 19.720286 6.716538 19.074363 +2569 447 4 0 18.977040 6.161032 19.255447 +2570 447 4 0 20.199596 6.784088 19.921433 +2571 448 6 0 -17.837323 -10.531279 11.466891 +2572 448 4 0 -18.443320 -10.286485 12.180075 +2573 448 4 0 -17.136906 -10.892709 12.057832 +2574 449 6 0 3.118617 16.201513 -14.560896 +2575 449 4 0 2.524275 15.456086 -14.261283 +2576 449 4 0 3.153477 16.211998 -15.545130 +2577 450 6 0 15.713269 9.977240 -3.550942 +2578 450 4 0 16.125798 10.839790 -3.855082 +2579 450 4 0 16.256998 9.663172 -2.774134 +2580 451 6 0 13.404328 14.288352 8.236302 +2581 451 4 0 13.804031 15.222512 8.339581 +2582 451 4 0 14.094703 13.583706 8.316160 +2583 452 6 0 1.715242 -17.595877 -5.517990 +2584 452 4 0 1.864739 -16.803207 -5.011472 +2585 452 4 0 1.121502 -17.292257 -6.152942 +2586 453 6 0 11.186181 -15.378074 -8.941210 +2587 453 4 0 10.964916 -15.109818 -9.814041 +2588 453 4 0 11.164732 -14.643976 -8.304569 +2589 454 6 0 -25.412651 0.765668 -5.618949 +2590 454 4 0 -25.840497 0.596705 -6.434188 +2591 454 4 0 -26.027451 1.074079 -4.940438 +2592 455 6 0 -11.380143 13.107124 -18.001950 +2593 455 4 0 -12.159770 13.386797 -17.518060 +2594 455 4 0 -11.627822 13.258638 -18.958908 +2595 456 6 0 7.443094 19.776722 19.670510 +2596 456 4 0 6.730151 19.191868 19.918965 +2597 456 4 0 7.622698 19.719431 18.722036 +2598 457 6 0 24.425946 4.299128 7.836287 +2599 457 4 0 24.143986 5.210765 7.985415 +2600 457 4 0 24.990386 4.054602 8.572061 +2601 458 6 0 -3.501704 -11.679155 -10.742632 +2602 458 4 0 -4.397462 -12.025343 -10.633214 +2603 458 4 0 -3.405610 -11.663721 -11.695424 +2604 459 6 0 0.913373 -18.230470 16.876362 +2605 459 4 0 0.053834 -18.577145 16.706546 +2606 459 4 0 1.398023 -19.065707 17.119688 +2607 460 6 0 -9.901596 19.393938 15.691257 +2608 460 4 0 -9.078500 18.954279 15.490614 +2609 460 4 0 -10.185869 18.992605 16.470215 +2610 461 6 0 17.500333 8.706246 -1.323866 +2611 461 4 0 18.176182 9.357546 -1.088149 +2612 461 4 0 17.886380 7.895975 -1.087485 +2613 462 6 0 -24.806806 -14.651049 -14.711674 +2614 462 4 0 -23.905722 -14.363057 -14.892641 +2615 462 4 0 -25.324843 -13.797568 -14.671497 +2616 463 6 0 -11.922848 -15.711273 -13.536344 +2617 463 4 0 -11.771327 -16.170114 -14.379176 +2618 463 4 0 -11.859275 -16.406199 -12.902056 +2619 464 6 0 -27.003017 7.585104 3.060101 +2620 464 4 0 -26.800446 6.932155 2.407207 +2621 464 4 0 -26.438815 7.393710 3.843574 +2622 465 6 0 -10.312090 7.223617 10.185454 +2623 465 4 0 -10.405406 7.379966 11.161275 +2624 465 4 0 -9.783333 6.436443 10.181461 +2625 466 6 0 23.537015 20.390749 -9.649267 +2626 466 4 0 23.323982 21.198505 -9.168669 +2627 466 4 0 23.931089 19.837314 -8.973454 +2628 467 6 0 -17.448795 -20.856696 -12.629322 +2629 467 4 0 -17.613855 -21.585186 -13.226336 +2630 467 4 0 -18.268235 -20.483922 -12.239203 +2631 468 6 0 -5.704053 -12.831319 -13.206852 +2632 468 4 0 -6.332034 -12.109323 -13.311978 +2633 468 4 0 -4.837836 -12.573450 -13.575508 +2634 469 6 0 -7.475606 18.168410 15.238194 +2635 469 4 0 -6.927022 17.679409 15.798229 +2636 469 4 0 -6.978971 18.983237 14.964387 +2637 470 6 0 23.258739 11.168040 16.596096 +2638 470 4 0 23.818087 11.847416 16.270136 +2639 470 4 0 23.610710 10.307417 16.344734 +2640 471 6 0 3.146606 8.327361 -18.713397 +2641 471 4 0 3.334432 7.845623 -19.520851 +2642 471 4 0 3.621381 9.175132 -18.785471 +2643 472 6 0 0.508878 16.181859 6.176221 +2644 472 4 0 1.478661 16.383107 6.127134 +2645 472 4 0 0.329178 16.140784 7.185704 +2646 473 6 0 -11.810390 15.699273 5.840977 +2647 473 4 0 -12.031355 16.450687 6.361038 +2648 473 4 0 -10.941390 15.840688 5.470174 +2649 474 6 0 16.703781 -6.435675 -7.458235 +2650 474 4 0 15.950366 -6.851824 -7.907248 +2651 474 4 0 16.319676 -6.119538 -6.579472 +2652 475 6 0 -16.104630 7.738737 15.683306 +2653 475 4 0 -15.741449 7.072122 15.101362 +2654 475 4 0 -15.325944 8.330995 15.966646 +2655 476 6 0 -12.982372 -5.391773 13.641043 +2656 476 4 0 -13.067158 -6.334773 13.565642 +2657 476 4 0 -13.835584 -5.074352 13.303582 +2658 477 6 0 -0.691433 15.384761 -9.798051 +2659 477 4 0 0.035655 15.975465 -9.534555 +2660 477 4 0 -1.411870 15.925295 -10.115684 +2661 478 6 0 22.895397 13.997330 -2.879616 +2662 478 4 0 23.276050 14.805518 -2.488993 +2663 478 4 0 21.981907 14.160579 -3.026251 +2664 479 6 0 -6.947442 -13.379975 4.783672 +2665 479 4 0 -6.469058 -13.127559 4.014561 +2666 479 4 0 -7.365275 -12.581164 5.147764 +2667 480 6 0 -6.156966 10.605862 2.666376 +2668 480 4 0 -6.752949 10.183956 3.255572 +2669 480 4 0 -5.588229 11.111653 3.195145 +2670 481 6 0 17.104300 -12.560553 4.419376 +2671 481 4 0 16.344172 -13.086998 4.734928 +2672 481 4 0 17.420711 -11.981042 5.141534 +2673 482 6 0 -27.199948 7.334242 -15.333048 +2674 482 4 0 -26.297948 6.895160 -15.306746 +2675 482 4 0 -27.693886 6.547850 -15.268217 +2676 483 6 0 18.024202 -19.856328 -19.395594 +2677 483 4 0 18.487766 -20.698158 -19.394705 +2678 483 4 0 17.496643 -19.929970 -20.262172 +2679 484 6 0 22.144036 -16.812143 16.683717 +2680 484 4 0 21.875393 -16.308766 15.860916 +2681 484 4 0 22.479620 -17.614693 16.338233 +2682 485 6 0 25.514687 -13.472113 7.132093 +2683 485 4 0 25.319079 -13.294653 8.096235 +2684 485 4 0 25.494887 -12.570062 6.821050 +2685 486 6 0 -12.445347 -17.163112 -18.161764 +2686 486 4 0 -13.331012 -16.853903 -17.823843 +2687 486 4 0 -12.475852 -18.105485 -18.058376 +2688 487 6 0 6.245110 16.618836 2.470683 +2689 487 4 0 5.362728 16.987415 2.415415 +2690 487 4 0 6.013984 15.709339 2.583315 +2691 488 6 0 -7.618060 -8.630004 1.461475 +2692 488 4 0 -8.009714 -7.788174 1.663581 +2693 488 4 0 -7.300014 -8.871099 2.309214 +2694 489 6 0 1.276161 -5.724890 -17.027124 +2695 489 4 0 0.639753 -5.451556 -16.374073 +2696 489 4 0 1.572713 -6.534640 -16.615769 +2697 490 6 0 20.941259 -12.865847 16.430327 +2698 490 4 0 21.406858 -13.389929 15.801253 +2699 490 4 0 21.410092 -12.085207 16.695307 +2700 491 6 0 18.670123 -9.367430 14.139852 +2701 491 4 0 17.803568 -9.004865 14.207764 +2702 491 4 0 18.435630 -10.292015 14.355155 +2703 492 6 0 15.733761 -0.209804 0.007017 +2704 492 4 0 15.513443 -0.802742 -0.762427 +2705 492 4 0 15.180436 -0.596633 0.738607 +2706 493 6 0 20.535815 18.401459 7.207233 +2707 493 4 0 20.172747 18.499555 8.120342 +2708 493 4 0 19.715556 18.443909 6.669483 +2709 494 6 0 -19.654075 2.825062 1.617329 +2710 494 4 0 -20.035859 3.209607 2.473368 +2711 494 4 0 -19.137175 3.619122 1.285240 +2712 495 6 0 -5.984107 19.675136 -16.959798 +2713 495 4 0 -5.160819 19.281994 -17.190879 +2714 495 4 0 -5.770973 20.610003 -16.990477 +2715 496 6 0 26.042716 7.197405 -0.343564 +2716 496 4 0 26.688586 6.461363 -0.227844 +2717 496 4 0 25.557638 7.239657 0.456505 +2718 497 6 0 22.024763 3.604615 -12.891547 +2719 497 4 0 21.193970 3.808969 -13.364435 +2720 497 4 0 22.195897 4.401136 -12.384999 +2721 498 6 0 -27.135160 -9.370585 20.643959 +2722 498 4 0 -28.030228 -9.176750 20.474699 +2723 498 4 0 -26.577987 -8.800343 20.128692 +2724 499 6 0 8.395602 -17.119113 3.456766 +2725 499 4 0 8.859834 -17.667269 2.833722 +2726 499 4 0 7.655636 -17.591648 3.745120 +2727 500 6 0 -24.404359 -0.181200 15.657271 +2728 500 4 0 -25.038728 0.161741 16.314921 +2729 500 4 0 -24.896501 -0.279136 14.882179 +2730 501 6 0 -6.891560 5.632315 -20.701537 +2731 501 4 0 -7.366523 6.287143 -21.223329 +2732 501 4 0 -7.630504 5.050659 -20.462604 +2733 502 6 0 -15.566391 -18.747028 -6.177602 +2734 502 4 0 -15.142312 -18.219593 -5.559758 +2735 502 4 0 -16.127679 -19.358388 -5.691405 +2736 503 6 0 -3.401719 -8.548294 5.789954 +2737 503 4 0 -3.203950 -7.652649 5.894670 +2738 503 4 0 -3.475505 -8.723091 4.829013 +2739 504 6 0 -14.869473 17.641299 -11.130330 +2740 504 4 0 -15.356466 18.395479 -10.824746 +2741 504 4 0 -14.164630 17.932079 -11.714816 +2742 505 6 0 -8.566470 9.810858 18.580750 +2743 505 4 0 -7.826026 10.409943 18.459685 +2744 505 4 0 -8.595914 9.242196 17.832030 +2745 506 6 0 15.884351 -0.825682 -9.976397 +2746 506 4 0 16.580456 -1.202192 -10.550817 +2747 506 4 0 16.179129 0.090931 -10.023947 +2748 507 6 0 -6.440363 -16.182406 14.932475 +2749 507 4 0 -5.547886 -16.002472 14.729390 +2750 507 4 0 -6.819275 -16.083044 14.039020 +2751 508 6 0 -15.767451 -12.920838 -5.752541 +2752 508 4 0 -14.944068 -12.805684 -5.287481 +2753 508 4 0 -15.473066 -13.122281 -6.647708 +2754 509 6 0 -17.665031 -20.836176 14.939409 +2755 509 4 0 -16.990389 -21.130134 14.286529 +2756 509 4 0 -18.400170 -20.675073 14.279982 +2757 510 6 0 -22.492854 -19.049287 15.743348 +2758 510 4 0 -23.226808 -19.456562 15.249983 +2759 510 4 0 -22.430818 -19.617870 16.566271 +2760 511 6 0 18.577331 8.130140 -4.339187 +2761 511 4 0 19.102086 8.936870 -4.101075 +2762 511 4 0 17.943090 8.097223 -3.622023 +2763 512 6 0 -8.059195 -11.528283 11.014399 +2764 512 4 0 -8.491272 -11.206486 10.183267 +2765 512 4 0 -7.559001 -12.278215 10.621240 +2766 513 6 0 -0.354476 13.050972 -11.242317 +2767 513 4 0 -0.049943 12.197330 -10.889757 +2768 513 4 0 -0.319360 13.679003 -10.509947 +2769 514 6 0 -22.692724 -6.768839 -13.959385 +2770 514 4 0 -22.638060 -6.234744 -13.112330 +2771 514 4 0 -22.909077 -7.637803 -13.626522 +2772 515 6 0 4.453531 -16.513982 -10.118567 +2773 515 4 0 5.009279 -17.005000 -9.492769 +2774 515 4 0 4.837806 -15.680507 -10.286610 +2775 516 6 0 -14.211895 -3.759096 -20.057898 +2776 516 4 0 -14.318355 -2.866044 -19.740155 +2777 516 4 0 -13.541901 -3.847665 -20.736218 +2778 517 6 0 26.693079 9.858450 -14.505848 +2779 517 4 0 26.995219 9.161898 -15.033866 +2780 517 4 0 25.767285 9.604872 -14.294807 +2781 518 6 0 -1.593304 -2.461499 11.764930 +2782 518 4 0 -0.575245 -2.524541 11.545614 +2783 518 4 0 -1.885036 -1.661756 11.286623 +2784 519 6 0 -19.660824 -20.494500 2.235869 +2785 519 4 0 -20.078029 -21.333649 2.487444 +2786 519 4 0 -19.181632 -20.681107 1.379436 +2787 520 6 0 4.144088 17.144901 -7.996934 +2788 520 4 0 4.141310 16.441147 -7.303669 +2789 520 4 0 3.204041 17.192031 -8.237159 +2790 521 6 0 24.148563 16.188551 14.675204 +2791 521 4 0 24.234269 17.058984 15.034647 +2792 521 4 0 23.773522 16.320292 13.788777 +2793 522 6 0 -11.859704 2.830217 -15.811214 +2794 522 4 0 -12.674780 3.212291 -15.481544 +2795 522 4 0 -11.777095 3.234540 -16.701788 +2796 523 6 0 -14.309989 12.182667 1.560506 +2797 523 4 0 -13.393237 12.215837 1.842065 +2798 523 4 0 -14.715876 12.517376 2.368763 +2799 524 6 0 -7.611903 8.096548 -15.149217 +2800 524 4 0 -8.323994 7.679983 -15.518143 +2801 524 4 0 -6.945506 8.015221 -15.887869 +2802 525 6 0 -19.095296 -11.187670 -3.400222 +2803 525 4 0 -19.337682 -11.939672 -2.902754 +2804 525 4 0 -18.131286 -10.890144 -3.347747 +2805 526 6 0 -3.684618 -18.692360 -9.413075 +2806 526 4 0 -3.418979 -17.929749 -9.940845 +2807 526 4 0 -2.916246 -19.202389 -9.257694 +2808 527 6 0 -24.383366 4.449647 -2.247488 +2809 527 4 0 -24.017217 3.645809 -1.897604 +2810 527 4 0 -24.220917 5.021187 -1.511294 +2811 528 6 0 -19.731647 -12.211221 2.860739 +2812 528 4 0 -19.245645 -12.129462 2.005512 +2813 528 4 0 -20.512036 -12.824760 2.628969 +2814 529 6 0 -4.683560 -15.770086 9.389938 +2815 529 4 0 -5.061246 -15.024625 8.860317 +2816 529 4 0 -5.320477 -16.506457 9.373591 +2817 530 6 0 -4.887399 -5.093738 -15.497549 +2818 530 4 0 -5.401164 -5.893295 -15.248311 +2819 530 4 0 -4.758120 -4.537262 -14.717756 +2820 531 6 0 -14.685481 -17.958902 -3.365836 +2821 531 4 0 -14.177516 -17.147605 -3.110889 +2822 531 4 0 -15.533211 -17.687906 -3.096067 +2823 532 6 0 24.950357 10.761179 -11.253927 +2824 532 4 0 25.623382 10.724523 -10.501653 +2825 532 4 0 24.912589 11.668740 -11.614144 +2826 533 6 0 5.896274 1.022377 5.410141 +2827 533 4 0 5.144364 0.409378 5.470882 +2828 533 4 0 6.702894 0.529043 5.601445 +2829 534 6 0 -10.707964 -12.538200 -15.636360 +2830 534 4 0 -11.433886 -12.205371 -16.086670 +2831 534 4 0 -10.099661 -13.047707 -16.220825 +2832 535 6 0 25.311857 10.178415 6.672916 +2833 535 4 0 25.652073 11.053667 6.645762 +2834 535 4 0 25.462543 9.793786 5.796182 +2835 536 6 0 13.351375 -13.843752 2.567223 +2836 536 4 0 12.454525 -14.099339 2.561046 +2837 536 4 0 13.804123 -14.196570 1.793439 +2838 537 6 0 6.447086 -1.674870 18.025371 +2839 537 4 0 6.966001 -2.437397 17.753314 +2840 537 4 0 5.596824 -1.849843 17.645605 +2841 538 6 0 -7.195562 13.506129 2.012549 +2842 538 4 0 -6.788362 12.635839 2.194379 +2843 538 4 0 -6.577836 13.973475 1.500153 +2844 539 6 0 13.594384 20.297397 2.445796 +2845 539 4 0 13.788282 19.607477 3.108308 +2846 539 4 0 13.006415 19.871282 1.852966 +2847 540 6 0 15.233611 0.850818 -5.243920 +2848 540 4 0 15.311708 1.467460 -4.483590 +2849 540 4 0 15.351381 1.519810 -6.000951 +2850 541 6 0 -21.392858 -6.660913 15.084747 +2851 541 4 0 -21.093136 -6.580317 16.005763 +2852 541 4 0 -20.482050 -6.866879 14.680665 +2853 542 6 0 21.798067 9.236981 0.429299 +2854 542 4 0 22.425954 9.071754 -0.267587 +2855 542 4 0 21.188410 9.810447 0.032847 +2856 543 6 0 -16.844679 -14.439050 3.033305 +2857 543 4 0 -17.236824 -14.606294 2.191567 +2858 543 4 0 -17.149528 -13.681189 3.446869 +2859 544 6 0 -16.118636 -14.695009 11.770906 +2860 544 4 0 -16.061462 -15.566570 12.219315 +2861 544 4 0 -15.401385 -14.815928 11.092232 +2862 545 6 0 -25.116635 -0.336266 -13.211265 +2863 545 4 0 -26.034773 -0.593788 -13.205266 +2864 545 4 0 -25.075870 0.263017 -13.996810 +2865 546 6 0 -20.959975 8.707771 -3.841257 +2866 546 4 0 -20.129335 8.189240 -3.711541 +2867 546 4 0 -21.648123 8.152127 -4.150679 +2868 547 6 0 -16.180937 -14.560529 -11.236167 +2869 547 4 0 -16.474551 -15.471407 -11.472150 +2870 547 4 0 -16.621414 -14.329172 -10.425074 +2871 548 6 0 -13.342695 17.268978 -5.546108 +2872 548 4 0 -13.676329 17.161979 -6.427016 +2873 548 4 0 -13.273106 16.392331 -5.194906 +2874 549 6 0 -24.265742 -14.933019 -6.702562 +2875 549 4 0 -23.594698 -14.475474 -7.192272 +2876 549 4 0 -24.769412 -14.353533 -6.144027 +2877 550 6 0 -7.448634 4.091980 -14.623254 +2878 550 4 0 -8.354031 4.372416 -14.477512 +2879 550 4 0 -7.429422 3.997857 -15.560262 +2880 551 6 0 20.945964 8.392028 7.273218 +2881 551 4 0 20.936526 8.748124 8.157739 +2882 551 4 0 21.409383 8.938927 6.671909 +2883 552 6 0 -18.135613 13.691026 0.855516 +2884 552 4 0 -17.605509 13.473951 1.604996 +2885 552 4 0 -17.989769 12.903203 0.328977 +2886 553 6 0 -26.399609 20.299424 -15.455568 +2887 553 4 0 -26.506532 19.402038 -15.778173 +2888 553 4 0 -27.208559 20.540561 -15.036657 +2889 554 6 0 -3.382080 16.857093 -8.397864 +2890 554 4 0 -3.374084 16.083688 -7.808965 +2891 554 4 0 -4.084724 16.687463 -9.043127 +2892 555 6 0 16.271526 -9.902746 -4.216439 +2893 555 4 0 16.409251 -10.505040 -3.454487 +2894 555 4 0 15.497720 -10.304168 -4.762308 +2895 556 6 0 14.340659 -16.032990 13.215463 +2896 556 4 0 13.501340 -15.882091 13.690140 +2897 556 4 0 14.455052 -15.349188 12.509336 +2898 557 6 0 -0.015146 -13.033200 3.303743 +2899 557 4 0 -0.181704 -13.007242 2.346702 +2900 557 4 0 0.267440 -13.997638 3.485458 +2901 558 6 0 17.219995 5.155984 2.579305 +2902 558 4 0 17.867362 4.521907 2.914585 +2903 558 4 0 17.421034 5.907098 3.091911 +2904 559 6 0 -4.290476 -8.859344 10.315396 +2905 559 4 0 -4.367776 -8.058305 9.793864 +2906 559 4 0 -4.232508 -9.643259 9.792086 +2907 560 6 0 -26.107401 19.840481 -9.535848 +2908 560 4 0 -25.152722 20.076292 -9.710007 +2909 560 4 0 -26.580648 20.657816 -9.784705 +2910 561 6 0 22.430740 12.824805 -18.610921 +2911 561 4 0 22.555563 12.342166 -17.752607 +2912 561 4 0 21.710766 13.488004 -18.415345 +2913 562 6 0 -0.213702 15.539427 8.868930 +2914 562 4 0 0.465115 15.308974 9.514310 +2915 562 4 0 -0.991140 15.165260 9.301737 +2916 563 6 0 10.451773 19.296672 -15.739638 +2917 563 4 0 11.250242 18.716315 -15.675225 +2918 563 4 0 10.166040 19.254066 -16.609341 +2919 564 6 0 -16.340404 20.299845 -6.677501 +2920 564 4 0 -15.394517 20.367214 -6.949699 +2921 564 4 0 -16.411819 19.609339 -6.000069 +2922 565 6 0 17.490554 18.048717 15.249869 +2923 565 4 0 17.383710 17.561453 14.453086 +2924 565 4 0 17.231849 18.986361 14.979711 +2925 566 6 0 -25.356900 0.960567 -15.630378 +2926 566 4 0 -25.668408 1.746466 -16.112686 +2927 566 4 0 -25.749312 0.266373 -16.283472 +2928 567 6 0 -24.523491 12.684913 -13.612913 +2929 567 4 0 -25.162839 13.082234 -14.200312 +2930 567 4 0 -24.857615 11.766450 -13.558078 +2931 568 6 0 -18.320478 -19.787535 -8.552256 +2932 568 4 0 -17.456232 -20.243682 -8.416866 +2933 568 4 0 -18.816764 -20.212417 -7.902570 +2934 569 6 0 -20.122796 -19.443402 14.311268 +2935 569 4 0 -20.955070 -19.458490 14.740741 +2936 569 4 0 -20.448309 -19.736012 13.412761 +2937 570 6 0 15.526182 9.609189 7.445275 +2938 570 4 0 16.546971 9.522464 7.260687 +2939 570 4 0 15.127662 8.717624 7.262881 +2940 571 6 0 21.815800 -13.876078 19.805359 +2941 571 4 0 21.861374 -13.448639 20.652235 +2942 571 4 0 20.873448 -13.977249 19.618277 +2943 572 6 0 -20.455209 -17.485281 2.435687 +2944 572 4 0 -20.514677 -18.504590 2.320539 +2945 572 4 0 -19.650253 -17.416617 3.035233 +2946 573 6 0 12.598962 20.934840 -8.411100 +2947 573 4 0 11.759105 20.691141 -7.924616 +2948 573 4 0 12.471156 20.908914 -9.376870 +2949 574 6 0 -9.216318 -10.756192 8.704342 +2950 574 4 0 -9.035829 -9.823066 8.964150 +2951 574 4 0 -10.158700 -10.965843 8.822969 +2952 575 6 0 15.481710 -19.357119 -11.731342 +2953 575 4 0 16.266851 -18.921549 -11.423511 +2954 575 4 0 15.782813 -20.280095 -11.705706 +2955 576 6 0 -15.247931 17.174276 -3.500551 +2956 576 4 0 -15.486872 16.716297 -4.319984 +2957 576 4 0 -14.488844 17.725770 -3.787040 +2958 577 6 0 13.994416 -17.236082 0.675362 +2959 577 4 0 14.353425 -17.278489 1.570062 +2960 577 4 0 14.236303 -16.341554 0.403337 +2961 578 6 0 -23.467726 19.561551 3.571514 +2962 578 4 0 -24.004822 19.287615 4.359125 +2963 578 4 0 -22.609407 19.390622 3.887076 +2964 579 6 0 -18.884839 -16.840019 19.441419 +2965 579 4 0 -17.972164 -16.942648 19.429089 +2966 579 4 0 -19.117567 -17.305223 18.656489 +2967 580 6 0 -3.304416 17.688255 14.806768 +2968 580 4 0 -3.274068 18.569163 15.273992 +2969 580 4 0 -3.909468 17.884508 14.115697 +2970 581 6 0 -17.284600 -14.419545 -3.713924 +2971 581 4 0 -17.245841 -15.056389 -4.407408 +2972 581 4 0 -16.814676 -13.644893 -4.121390 +2973 582 6 0 -20.198946 13.854179 -11.126603 +2974 582 4 0 -19.842134 14.641594 -10.704689 +2975 582 4 0 -20.994231 13.579588 -10.762730 +2976 583 6 0 19.633175 -4.534579 -1.940156 +2977 583 4 0 20.573656 -4.404910 -1.787896 +2978 583 4 0 19.476036 -5.006335 -2.786939 +2979 584 6 0 -14.050747 -7.840313 -20.451392 +2980 584 4 0 -13.804502 -7.885621 -19.536069 +2981 584 4 0 -14.163116 -8.770871 -20.729134 +2982 585 6 0 -22.035810 -14.696947 -15.342419 +2983 585 4 0 -21.244458 -14.172213 -14.968853 +2984 585 4 0 -21.709618 -15.071176 -16.129917 +2985 586 6 0 24.404519 18.662499 15.604580 +2986 586 4 0 23.649634 19.231742 15.720672 +2987 586 4 0 24.564861 18.257635 16.462026 +2988 587 6 0 -25.023703 1.632995 9.069342 +2989 587 4 0 -24.924833 0.728361 9.205894 +2990 587 4 0 -25.848027 1.691778 8.537435 +2991 588 6 0 -23.501597 20.098664 7.878789 +2992 588 4 0 -23.060988 19.669189 7.073786 +2993 588 4 0 -24.179799 19.453525 8.025704 +2994 589 6 0 -19.949605 3.791557 -8.640569 +2995 589 4 0 -20.735484 4.236110 -9.006112 +2996 589 4 0 -20.021037 3.910265 -7.668204 +2997 590 6 0 -11.039604 7.965462 12.985718 +2998 590 4 0 -11.657528 7.295810 13.344834 +2999 590 4 0 -11.533657 8.735729 12.733347 +3000 591 6 0 -10.874373 -9.234080 16.940331 +3001 591 4 0 -10.287226 -8.454268 16.808084 +3002 591 4 0 -10.829657 -9.367499 17.890097 +3003 592 6 0 -14.385649 -14.739019 19.039927 +3004 592 4 0 -15.014366 -15.430322 18.739868 +3005 592 4 0 -13.950162 -14.385374 18.202705 +3006 593 6 0 -8.943007 -18.707640 -12.863046 +3007 593 4 0 -8.324251 -18.030317 -12.441569 +3008 593 4 0 -8.503951 -19.555164 -12.986191 +3009 594 6 0 -12.368468 -11.299670 18.862003 +3010 594 4 0 -11.462838 -11.162374 19.089512 +3011 594 4 0 -12.285975 -11.967140 18.162474 +3012 595 6 0 -18.864908 10.893225 -18.642183 +3013 595 4 0 -19.737729 11.286548 -18.797146 +3014 595 4 0 -18.291730 11.691326 -18.413733 +3015 596 6 0 13.738555 -10.387697 15.727067 +3016 596 4 0 14.677946 -10.190824 15.738680 +3017 596 4 0 13.381035 -9.878174 14.979047 +3018 597 6 0 -21.819721 -0.482540 -14.130337 +3019 597 4 0 -22.018580 0.101499 -14.814948 +3020 597 4 0 -21.732054 0.043937 -13.284517 +3021 598 6 0 -22.088145 -19.005770 -10.424446 +3022 598 4 0 -22.700458 -18.735873 -11.127116 +3023 598 4 0 -22.265806 -18.243802 -9.851663 +3024 599 6 0 -27.334131 16.862943 6.388414 +3025 599 4 0 -27.128884 17.208336 5.542208 +3026 599 4 0 -28.186942 16.459356 6.245911 +3027 600 6 0 -7.724914 11.617317 -15.852447 +3028 600 4 0 -7.898781 11.683763 -14.888607 +3029 600 4 0 -7.243883 12.459704 -15.934395 +3030 601 6 0 -27.430510 7.062419 7.641894 +3031 601 4 0 -28.241619 7.496835 7.830929 +3032 601 4 0 -26.905937 6.864821 8.456222 +3033 602 6 0 -15.189130 9.068233 11.973047 +3034 602 4 0 -15.507439 9.270556 11.066477 +3035 602 4 0 -16.000569 9.109399 12.508881 +3036 603 6 0 18.197719 -8.444367 -5.807006 +3037 603 4 0 17.669265 -7.953475 -6.477556 +3038 603 4 0 17.491033 -8.840952 -5.199557 +3039 604 6 0 -17.798267 -15.359279 0.720984 +3040 604 4 0 -17.605358 -16.253295 0.449070 +3041 604 4 0 -18.769315 -15.298569 0.739208 +3042 605 6 0 -10.801299 19.625083 -5.021468 +3043 605 4 0 -9.963843 19.123292 -5.234694 +3044 605 4 0 -10.501894 20.547773 -4.927487 +3045 606 6 0 -27.215648 6.353394 -6.216686 +3046 606 4 0 -27.824477 6.975672 -6.597897 +3047 606 4 0 -27.715217 5.539077 -6.142494 +3048 607 6 0 -20.222710 16.482564 20.889728 +3049 607 4 0 -19.409945 15.875063 20.936404 +3050 607 4 0 -20.827135 16.165289 21.596363 +3051 608 6 0 -15.955148 20.970093 -1.473146 +3052 608 4 0 -16.254513 20.076270 -1.042106 +3053 608 4 0 -15.662348 21.552087 -0.814219 +3054 609 6 0 10.807526 -13.982475 1.662510 +3055 609 4 0 10.120672 -14.259351 2.204544 +3056 609 4 0 10.863967 -13.021251 1.772688 +3057 610 6 0 -7.966458 -18.779639 13.245673 +3058 610 4 0 -7.309099 -18.332730 12.718011 +3059 610 4 0 -8.719738 -18.984231 12.613154 +3060 611 6 0 -20.403821 -13.506340 10.662924 +3061 611 4 0 -20.510093 -14.184751 11.331921 +3062 611 4 0 -19.449692 -13.488641 10.607253 +3063 612 6 0 3.347403 17.582790 14.279585 +3064 612 4 0 3.542375 16.697267 14.539882 +3065 612 4 0 3.842808 18.157712 14.875497 +3066 613 6 0 -27.268704 11.599332 7.521962 +3067 613 4 0 -27.319935 12.603952 7.610238 +3068 613 4 0 -27.760414 11.222738 8.251319 +3069 614 6 0 -13.558625 -13.571833 9.018373 +3070 614 4 0 -14.134501 -13.113855 9.622383 +3071 614 4 0 -13.282735 -12.952963 8.287428 +3072 615 6 0 -12.904629 4.779698 8.188511 +3073 615 4 0 -12.946789 5.709486 7.819080 +3074 615 4 0 -13.125056 4.225008 7.389046 +3075 616 6 0 -26.521845 8.632500 -1.585840 +3076 616 4 0 -27.252112 8.571224 -0.926514 +3077 616 4 0 -27.101821 8.697912 -2.395641 +3078 617 6 0 0.711352 18.247453 15.282784 +3079 617 4 0 1.603697 18.249814 14.962197 +3080 617 4 0 0.201613 17.732907 14.670147 +3081 618 6 0 7.113451 16.228888 -1.466776 +3082 618 4 0 7.173117 15.305699 -1.111399 +3083 618 4 0 7.220512 16.670305 -0.601189 +3084 619 6 0 -13.904243 8.625524 20.904818 +3085 619 4 0 -14.598235 8.427161 20.276223 +3086 619 4 0 -13.595573 9.537530 20.812383 +3087 620 6 0 -23.282747 7.422865 -4.367991 +3088 620 4 0 -23.494082 7.124036 -5.259399 +3089 620 4 0 -24.056516 7.114406 -3.864243 +3090 621 6 0 -14.263410 11.647626 -16.485013 +3091 621 4 0 -14.250457 12.591263 -16.217484 +3092 621 4 0 -13.447733 11.223560 -16.266518 +3093 622 6 0 -25.123489 -11.752131 6.663069 +3094 622 4 0 -24.434538 -11.175706 6.315833 +3095 622 4 0 -24.632736 -12.584077 6.767142 +3096 623 6 0 -14.146070 -17.326290 5.680123 +3097 623 4 0 -13.644335 -16.487658 5.902302 +3098 623 4 0 -14.878124 -17.344106 6.279009 +3099 624 6 0 -20.598314 9.096753 20.421892 +3100 624 4 0 -21.420000 9.436011 20.788368 +3101 624 4 0 -20.773261 8.800990 19.535216 +3102 625 6 0 18.231067 -8.355182 -15.374644 +3103 625 4 0 19.158997 -8.699272 -15.469475 +3104 625 4 0 18.162062 -7.866000 -14.601450 +3105 626 6 0 -26.082795 17.419257 -15.113528 +3106 626 4 0 -26.663305 16.880075 -15.659385 +3107 626 4 0 -26.614420 17.764627 -14.366811 +3108 627 6 0 -4.564502 -6.365364 18.192018 +3109 627 4 0 -4.423912 -6.577366 17.248668 +3110 627 4 0 -4.413382 -7.162274 18.732886 +3111 628 6 0 2.994631 -20.344673 -10.462592 +3112 628 4 0 3.336979 -19.647973 -11.071544 +3113 628 4 0 2.839013 -21.162093 -11.031196 +3114 629 6 0 -18.808948 18.745667 8.606647 +3115 629 4 0 -18.793078 17.928925 9.047490 +3116 629 4 0 -19.375318 18.782786 7.854831 +3117 630 6 0 20.293384 6.483656 -8.185168 +3118 630 4 0 19.822775 6.335085 -7.339796 +3119 630 4 0 19.910867 5.733330 -8.676027 +3120 631 6 0 14.001637 -11.377427 6.654390 +3121 631 4 0 14.665802 -10.891103 7.186571 +3122 631 4 0 13.155623 -11.243569 7.110824 +3123 632 6 0 -18.716197 16.452296 -6.146582 +3124 632 4 0 -17.737092 16.308167 -6.065641 +3125 632 4 0 -18.803071 17.441704 -6.266673 +3126 633 6 0 -9.164502 -4.245435 9.687071 +3127 633 4 0 -9.504754 -3.618059 10.271725 +3128 633 4 0 -8.758976 -4.901714 10.277390 +3129 634 6 0 -7.567104 17.996846 -14.273209 +3130 634 4 0 -7.423981 17.432000 -15.103459 +3131 634 4 0 -7.626914 17.354562 -13.501068 +3132 635 6 0 25.957404 18.297560 0.964228 +3133 635 4 0 26.373386 18.902213 1.607245 +3134 635 4 0 24.996135 18.298154 0.948557 +3135 636 6 0 27.365655 -19.507447 4.283366 +3136 636 4 0 27.265808 -18.590346 4.470644 +3137 636 4 0 27.346229 -19.502059 3.318095 +3138 637 6 0 3.399017 3.842973 -14.306661 +3139 637 4 0 3.874219 4.645706 -14.438487 +3140 637 4 0 3.960550 3.060792 -14.302404 +3141 638 6 0 -9.633558 -14.252688 -13.074954 +3142 638 4 0 -10.397961 -14.800052 -13.280458 +3143 638 4 0 -9.599658 -13.580050 -13.748986 +3144 639 6 0 -26.597184 -9.526044 16.214934 +3145 639 4 0 -25.761551 -9.704064 15.705422 +3146 639 4 0 -26.282395 -9.291353 17.107825 +3147 640 6 0 9.904852 -8.080714 13.028578 +3148 640 4 0 9.633649 -8.672937 13.775436 +3149 640 4 0 9.328640 -8.216914 12.289674 +3150 641 6 0 -16.656465 -15.275719 14.920535 +3151 641 4 0 -16.332015 -16.176602 15.149012 +3152 641 4 0 -17.604168 -15.312599 15.097227 +3153 642 6 0 -23.632856 16.383578 4.244499 +3154 642 4 0 -24.439865 15.907903 4.567947 +3155 642 4 0 -23.758905 16.459340 3.297146 +3156 643 6 0 6.174822 3.396366 6.558333 +3157 643 4 0 6.411031 3.086511 7.491490 +3158 643 4 0 5.914298 2.639627 6.072475 +3159 644 6 0 -12.394642 12.999960 5.615295 +3160 644 4 0 -12.767249 13.829992 5.894454 +3161 644 4 0 -11.542368 12.942527 6.067628 +3162 645 6 0 -13.943061 -10.506777 -8.106784 +3163 645 4 0 -14.282580 -10.512566 -7.188555 +3164 645 4 0 -13.832495 -9.541181 -8.393822 +3165 646 6 0 -2.132377 12.062639 -15.645930 +3166 646 4 0 -2.521581 12.726985 -15.116060 +3167 646 4 0 -2.383415 12.256835 -16.605675 +3168 647 6 0 -15.781380 4.295423 -12.837615 +3169 647 4 0 -16.545564 4.857521 -12.623883 +3170 647 4 0 -14.991403 4.649584 -12.386947 +3171 648 6 0 3.657686 -14.899636 11.284985 +3172 648 4 0 4.599918 -15.027083 11.351362 +3173 648 4 0 3.451904 -14.114684 10.742312 +3174 649 6 0 -13.445931 -12.269834 -16.644595 +3175 649 4 0 -13.143553 -12.206221 -17.543310 +3176 649 4 0 -14.277341 -11.802665 -16.570144 +3177 650 6 0 -4.514598 -14.412565 -11.239008 +3178 650 4 0 -4.912249 -14.782052 -10.430067 +3179 650 4 0 -5.207582 -13.911802 -11.682506 +3180 651 6 0 -22.202449 -8.277754 -0.156304 +3181 651 4 0 -21.822932 -9.154115 -0.107154 +3182 651 4 0 -22.081748 -7.881016 0.675063 +3183 652 6 0 5.980605 9.643233 7.937147 +3184 652 4 0 5.778293 9.935793 8.831204 +3185 652 4 0 6.322796 10.408255 7.426496 +3186 653 6 0 -2.201607 -16.515113 -14.210032 +3187 653 4 0 -2.059974 -15.558981 -14.035317 +3188 653 4 0 -1.990188 -17.058199 -13.410631 +3189 654 6 0 18.679591 -18.705711 14.460946 +3190 654 4 0 18.696979 -17.793354 14.872009 +3191 654 4 0 19.598133 -18.732862 14.241557 +3192 655 6 0 -23.704300 9.078870 13.078638 +3193 655 4 0 -23.670653 8.205186 13.541582 +3194 655 4 0 -24.192847 9.646015 13.627775 +3195 656 6 0 -2.173657 16.833015 -11.939576 +3196 656 4 0 -1.811491 16.347920 -12.704849 +3197 656 4 0 -1.445451 17.452841 -11.775832 +3198 657 6 0 13.483501 -11.256705 11.913651 +3199 657 4 0 12.870120 -10.662512 12.431360 +3200 657 4 0 14.331458 -10.851122 11.936251 +3201 658 6 0 24.414471 -17.245267 11.179269 +3202 658 4 0 25.211262 -16.789228 11.385933 +3203 658 4 0 24.640242 -18.219159 11.091473 +3204 659 6 0 11.120331 -15.111988 5.927148 +3205 659 4 0 11.451561 -14.918986 6.814295 +3206 659 4 0 11.019394 -14.187742 5.582882 +3207 660 6 0 12.007104 -9.600387 4.572911 +3208 660 4 0 11.779325 -9.981896 3.630934 +3209 660 4 0 12.299473 -8.663707 4.379041 +3210 661 6 0 6.432204 5.492806 -11.438378 +3211 661 4 0 6.858563 6.325600 -11.691904 +3212 661 4 0 5.497288 5.536187 -11.496269 +3213 662 6 0 -16.803408 -2.309975 -12.525084 +3214 662 4 0 -17.553689 -1.730249 -12.823644 +3215 662 4 0 -17.150179 -3.188627 -12.867169 +3216 663 6 0 -2.408853 19.363640 5.416041 +3217 663 4 0 -2.506588 20.324223 5.172630 +3218 663 4 0 -1.499205 19.245311 4.997471 +3219 664 6 0 18.335645 9.820504 -20.835302 +3220 664 4 0 17.802051 9.406337 -21.556671 +3221 664 4 0 19.054571 10.173338 -21.326492 +3222 665 6 0 14.492400 -0.793925 15.043220 +3223 665 4 0 15.273199 -0.763837 15.602226 +3224 665 4 0 13.903082 -0.202173 15.510237 +3225 666 6 0 -18.990417 -18.003103 -15.160778 +3226 666 4 0 -19.065422 -18.467887 -14.363137 +3227 666 4 0 -18.682751 -18.771930 -15.707456 +3228 667 6 0 -19.355981 10.428580 -15.655699 +3229 667 4 0 -18.958237 10.419569 -16.503824 +3230 667 4 0 -19.555621 9.469325 -15.477396 +3231 668 6 0 -9.689572 -17.625802 20.274891 +3232 668 4 0 -9.638458 -16.856491 19.680753 +3233 668 4 0 -10.446575 -18.157818 20.089513 +3234 669 6 0 15.818186 -2.858530 -17.669337 +3235 669 4 0 15.374117 -2.032149 -17.355590 +3236 669 4 0 16.772354 -2.603400 -17.785321 +3237 670 6 0 4.606592 -16.002710 16.812249 +3238 670 4 0 5.315620 -15.500456 17.249944 +3239 670 4 0 3.799748 -15.479801 16.918622 +3240 671 6 0 -21.513339 9.988705 -9.339870 +3241 671 4 0 -20.667999 10.159257 -9.025723 +3242 671 4 0 -21.969690 9.708425 -8.552482 +3243 672 6 0 22.932065 -4.395951 1.502838 +3244 672 4 0 23.014854 -3.682098 2.132967 +3245 672 4 0 22.755233 -5.203260 2.068576 +3246 673 6 0 -15.865161 20.547416 -16.433392 +3247 673 4 0 -15.771392 21.394273 -16.845693 +3248 673 4 0 -15.137003 20.501933 -15.748936 +3249 674 6 0 25.069907 -16.838970 -4.299599 +3250 674 4 0 25.999382 -16.506367 -4.277797 +3251 674 4 0 24.882196 -17.073394 -3.399165 +3252 675 6 0 12.210843 -6.139817 11.421079 +3253 675 4 0 11.494183 -5.792293 10.826764 +3254 675 4 0 12.753399 -6.598677 10.772296 +3255 676 6 0 -12.958185 15.721214 20.131937 +3256 676 4 0 -12.417015 15.448234 19.335440 +3257 676 4 0 -12.670185 16.622230 20.361377 +3258 677 6 0 -1.787017 -16.482436 -2.383044 +3259 677 4 0 -1.225925 -16.053148 -3.012278 +3260 677 4 0 -2.501380 -15.880251 -2.214679 +3261 678 6 0 -1.190078 -20.139554 1.294226 +3262 678 4 0 -0.299194 -20.371113 0.969279 +3263 678 4 0 -1.688402 -19.692251 0.619486 +3264 679 6 0 1.937567 -19.455705 20.174807 +3265 679 4 0 1.600890 -18.656647 20.650502 +3266 679 4 0 2.270116 -20.076098 20.862273 +3267 680 6 0 -13.809787 16.178967 11.484043 +3268 680 4 0 -14.142545 15.377181 11.850775 +3269 680 4 0 -14.373329 16.882494 11.935295 +3270 681 6 0 17.196672 -3.298677 9.603341 +3271 681 4 0 17.785156 -3.273949 10.352111 +3272 681 4 0 16.328249 -3.307055 9.989818 +3273 682 6 0 -21.793083 12.953802 -3.361588 +3274 682 4 0 -21.341354 13.824014 -3.442583 +3275 682 4 0 -21.956486 12.886091 -2.420332 +3276 683 6 0 24.722833 -20.214271 -1.932412 +3277 683 4 0 24.583170 -20.295689 -2.905459 +3278 683 4 0 25.266330 -20.988208 -1.659517 +3279 684 6 0 13.576953 15.549687 -14.568922 +3280 684 4 0 13.196035 16.082140 -13.845167 +3281 684 4 0 12.903095 14.935032 -14.704323 +3282 685 6 0 24.686323 18.724782 9.264820 +3283 685 4 0 25.356258 19.231143 8.760904 +3284 685 4 0 24.376076 19.091122 10.133820 +3285 686 6 0 10.974277 8.210457 0.042398 +3286 686 4 0 10.346946 8.747962 0.639501 +3287 686 4 0 11.775308 8.082914 0.592641 +3288 687 6 0 15.749941 -9.949096 -10.535727 +3289 687 4 0 14.881677 -9.994266 -10.933909 +3290 687 4 0 16.082746 -9.069742 -10.712222 +3291 688 6 0 20.372551 -2.740524 -20.295283 +3292 688 4 0 19.972569 -3.556917 -19.910575 +3293 688 4 0 21.117159 -2.669954 -19.650483 +3294 689 6 0 -16.130593 19.525141 7.609103 +3295 689 4 0 -16.988329 19.095523 7.574165 +3296 689 4 0 -15.815635 19.368486 8.484111 +3297 690 6 0 -13.620470 -12.179873 -20.763485 +3298 690 4 0 -13.206848 -12.281384 -21.584939 +3299 690 4 0 -13.003543 -11.952064 -20.092320 +3300 691 6 0 -4.286145 -8.076676 -19.850653 +3301 691 4 0 -4.024629 -8.962570 -19.497729 +3302 691 4 0 -4.628013 -8.265378 -20.732144 +3303 692 6 0 18.167149 11.171401 14.365772 +3304 692 4 0 18.072419 11.267858 15.337991 +3305 692 4 0 19.114984 11.092302 14.227006 +3306 693 6 0 -6.484207 14.268929 15.251307 +3307 693 4 0 -5.622289 14.569256 15.414810 +3308 693 4 0 -6.409671 13.589284 14.542615 +3309 694 6 0 -22.009910 15.740037 8.254841 +3310 694 4 0 -21.174881 15.566577 7.788279 +3311 694 4 0 -21.784303 15.725302 9.211467 +3312 695 6 0 -12.075884 4.855934 18.759604 +3313 695 4 0 -11.922580 5.826978 18.890965 +3314 695 4 0 -11.210639 4.506344 19.097368 +3315 696 6 0 10.488011 -18.196911 -8.466384 +3316 696 4 0 10.637969 -17.211540 -8.520849 +3317 696 4 0 11.163762 -18.500106 -9.085738 +3318 697 6 0 1.125820 20.066151 11.277514 +3319 697 4 0 0.488344 19.358887 11.406985 +3320 697 4 0 1.175707 20.424035 12.220043 +3321 698 6 0 1.508244 -2.375369 14.307932 +3322 698 4 0 0.868346 -1.761280 14.698396 +3323 698 4 0 1.257101 -3.281035 14.657092 +3324 699 6 0 8.333201 -20.303098 14.135689 +3325 699 4 0 8.173342 -20.812430 14.996202 +3326 699 4 0 7.563231 -20.469348 13.580696 +3327 700 6 0 7.161769 13.324939 -3.684466 +3328 700 4 0 6.692561 13.032914 -4.505707 +3329 700 4 0 7.435294 14.252208 -3.751921 +3330 701 6 0 -8.368806 1.641675 18.686706 +3331 701 4 0 -7.449000 1.561105 18.992044 +3332 701 4 0 -8.829402 1.367359 19.523867 +3333 702 6 0 4.081470 8.393376 14.788004 +3334 702 4 0 3.416356 8.289314 15.434673 +3335 702 4 0 3.901559 7.693490 14.181822 +3336 703 6 0 -7.418847 -5.372814 17.842250 +3337 703 4 0 -7.820918 -6.206339 17.693835 +3338 703 4 0 -6.460103 -5.466581 17.841167 +3339 704 6 0 -6.272338 -9.280731 3.614771 +3340 704 4 0 -5.671659 -9.851333 3.097194 +3341 704 4 0 -6.583386 -9.880058 4.252855 +3342 705 6 0 26.867212 -7.498721 15.184014 +3343 705 4 0 27.180613 -8.176302 15.786609 +3344 705 4 0 27.338168 -7.770453 14.373438 +3345 706 6 0 9.996033 -14.570233 13.333736 +3346 706 4 0 9.969634 -13.724445 12.959529 +3347 706 4 0 9.789000 -15.194125 12.559782 +3348 707 6 0 2.391061 -15.016416 -4.564378 +3349 707 4 0 2.249440 -15.150315 -3.614545 +3350 707 4 0 3.332088 -14.950210 -4.710721 +3351 708 6 0 -21.651564 17.273027 -5.114431 +3352 708 4 0 -22.612266 17.402180 -4.967856 +3353 708 4 0 -21.475301 17.110688 -6.035544 +3354 709 6 0 10.670434 18.798919 9.295678 +3355 709 4 0 10.772878 18.810256 8.313948 +3356 709 4 0 10.935580 19.678994 9.619801 +3357 710 6 0 8.580286 -14.501479 3.135425 +3358 710 4 0 8.621343 -14.445805 4.107721 +3359 710 4 0 8.542982 -15.491097 3.062040 +3360 711 6 0 -14.377865 -7.995183 14.343301 +3361 711 4 0 -14.100201 -8.614257 14.993234 +3362 711 4 0 -14.866324 -7.355345 14.871637 +3363 712 6 0 -0.977425 16.774193 13.640180 +3364 712 4 0 -0.958949 17.266593 12.835191 +3365 712 4 0 -1.881684 16.955536 13.931092 +3366 713 6 0 -15.828708 -3.415349 7.406744 +3367 713 4 0 -16.180618 -3.426100 6.520488 +3368 713 4 0 -16.669651 -3.380771 7.995037 +3369 714 6 0 -12.774799 -8.235123 -12.889327 +3370 714 4 0 -12.978669 -7.282136 -13.083792 +3371 714 4 0 -13.615071 -8.678664 -13.235742 +3372 715 6 0 2.845289 0.060180 20.134181 +3373 715 4 0 2.858756 0.453048 19.232311 +3374 715 4 0 1.957136 -0.331348 20.300492 +3375 716 6 0 24.984643 -14.973253 -17.474954 +3376 716 4 0 25.370717 -15.847238 -17.382478 +3377 716 4 0 25.194569 -14.524794 -16.625306 +3378 717 6 0 13.620247 -7.920957 7.008348 +3379 717 4 0 14.470702 -8.278296 6.767655 +3380 717 4 0 13.126236 -7.674429 6.169358 +3381 718 6 0 17.636081 -10.073874 3.386982 +3382 718 4 0 17.376472 -9.849973 2.460148 +3383 718 4 0 17.541385 -10.988029 3.459151 +3384 719 6 0 -23.876026 -12.063687 -5.995846 +3385 719 4 0 -24.585420 -12.252172 -5.420831 +3386 719 4 0 -23.110219 -12.523733 -5.650434 +3387 720 6 0 -23.535607 1.699271 1.932031 +3388 720 4 0 -24.143027 1.031548 1.814474 +3389 720 4 0 -23.866587 2.338510 2.606284 +3390 721 6 0 13.720565 9.351789 12.307976 +3391 721 4 0 13.899370 10.225405 12.040604 +3392 721 4 0 13.192298 9.477241 13.121209 +3393 722 6 0 15.291476 15.170550 12.140656 +3394 722 4 0 14.287956 15.135496 12.069067 +3395 722 4 0 15.572140 14.570493 11.432982 +3396 723 6 0 -10.060226 -11.465180 13.094454 +3397 723 4 0 -9.757397 -11.240849 13.961157 +3398 723 4 0 -9.428065 -11.417927 12.436211 +3399 724 6 0 -19.840622 -4.281655 -17.053557 +3400 724 4 0 -20.444679 -3.559033 -16.740868 +3401 724 4 0 -20.093102 -5.062268 -16.449961 +3402 725 6 0 -11.088232 19.299933 12.989268 +3403 725 4 0 -11.278861 18.327556 12.943710 +3404 725 4 0 -10.555994 19.370336 13.806383 +3405 726 6 0 14.192836 -14.527612 16.897429 +3406 726 4 0 13.394071 -15.012895 17.049022 +3407 726 4 0 14.074952 -14.064189 16.039244 +3408 727 6 0 5.078670 -4.434084 15.727807 +3409 727 4 0 5.834022 -4.419315 16.349614 +3410 727 4 0 5.405954 -4.558925 14.872493 +3411 728 6 0 -19.510762 -4.936357 -8.682052 +3412 728 4 0 -18.583830 -4.871299 -8.739257 +3413 728 4 0 -19.725350 -4.373920 -7.917441 +3414 729 6 0 6.637127 -10.197837 -8.914867 +3415 729 4 0 7.303561 -10.846941 -9.129195 +3416 729 4 0 7.018008 -9.736820 -8.200293 +3417 730 6 0 -23.721355 20.227172 -16.438294 +3418 730 4 0 -24.533045 20.118818 -15.892499 +3419 730 4 0 -24.022901 20.350741 -17.335304 +3420 731 6 0 -0.030599 -15.820284 7.354097 +3421 731 4 0 -0.675125 -15.374015 6.761895 +3422 731 4 0 -0.583629 -16.217933 8.065590 +3423 732 6 0 17.878609 -6.751885 -17.518842 +3424 732 4 0 17.903391 -7.334049 -16.742820 +3425 732 4 0 17.140042 -7.214968 -18.038372 +3426 733 6 0 -5.849569 3.309930 19.753024 +3427 733 4 0 -6.252138 4.072448 20.161965 +3428 733 4 0 -5.149208 3.038493 20.337689 +3429 734 6 0 -24.710885 -6.308647 13.490216 +3430 734 4 0 -25.586238 -6.177846 13.106753 +3431 734 4 0 -24.889314 -6.461576 14.430169 +3432 735 6 0 -11.604329 -16.031249 -0.237137 +3433 735 4 0 -10.966421 -16.304157 -0.881127 +3434 735 4 0 -11.170811 -15.476610 0.378509 +3435 736 6 0 21.103321 -18.752766 6.405335 +3436 736 4 0 21.283349 -17.950114 6.943720 +3437 736 4 0 21.235391 -18.472219 5.506239 +3438 737 6 0 -0.369145 -20.712312 19.095306 +3439 737 4 0 0.355231 -20.367028 19.676247 +3440 737 4 0 -1.186977 -20.260183 19.421119 +3441 738 6 0 13.869578 -2.965624 18.758945 +3442 738 4 0 13.547281 -3.390529 19.570053 +3443 738 4 0 14.278344 -2.158860 19.065428 +3444 739 6 0 -15.806264 2.737988 -2.216704 +3445 739 4 0 -16.485177 2.180539 -1.805532 +3446 739 4 0 -15.814791 2.396599 -3.131246 +3447 740 6 0 -11.766416 -8.088239 8.837485 +3448 740 4 0 -11.812419 -8.926527 9.226533 +3449 740 4 0 -12.558194 -7.583042 9.186828 +3450 741 6 0 23.076788 16.678629 12.104295 +3451 741 4 0 23.468754 16.241536 11.310898 +3452 741 4 0 22.132874 16.713960 11.904816 +3453 742 6 0 -14.202464 -15.765503 -5.593495 +3454 742 4 0 -14.871838 -15.026911 -5.676361 +3455 742 4 0 -13.955401 -15.992753 -6.481500 +3456 743 6 0 15.150303 11.672770 19.298045 +3457 743 4 0 15.470730 12.261881 18.627217 +3458 743 4 0 15.518028 11.969931 20.141796 +3459 744 6 0 9.848503 -12.101587 -10.529245 +3460 744 4 0 10.607536 -11.738045 -10.041608 +3461 744 4 0 9.985842 -11.615457 -11.376399 +3462 745 6 0 2.125570 -11.875883 -16.645987 +3463 745 4 0 2.047554 -12.712083 -16.165814 +3464 745 4 0 2.067413 -12.170151 -17.579365 +3465 746 6 0 -5.977611 10.651495 7.046682 +3466 746 4 0 -5.213541 10.455986 7.620137 +3467 746 4 0 -6.494562 9.846985 7.169759 +3468 747 6 0 -16.351535 -7.485266 -9.424947 +3469 747 4 0 -16.745079 -6.668906 -9.070767 +3470 747 4 0 -16.602332 -8.158689 -8.798627 +3471 748 6 0 24.296678 -17.192464 4.785797 +3472 748 4 0 24.587865 -18.035334 5.123313 +3473 748 4 0 24.068802 -16.574501 5.523851 +3474 749 6 0 -10.968856 -18.323021 -8.138707 +3475 749 4 0 -11.363544 -18.853138 -8.863013 +3476 749 4 0 -10.206142 -17.988660 -8.562061 +3477 750 6 0 -9.854962 -9.956148 -15.278228 +3478 750 4 0 -10.293465 -9.897483 -14.451993 +3479 750 4 0 -9.970473 -10.887047 -15.573043 +3480 751 6 0 -2.935483 6.363032 -19.045018 +3481 751 4 0 -3.535132 5.588364 -18.854687 +3482 751 4 0 -3.494550 7.145960 -19.014910 +3483 752 6 0 5.112400 17.701587 -11.443651 +3484 752 4 0 5.575170 17.705031 -12.266361 +3485 752 4 0 5.677404 18.265335 -10.960537 +3486 753 6 0 -6.450118 17.009140 6.526693 +3487 753 4 0 -6.743394 16.108032 6.566324 +3488 753 4 0 -5.677664 17.076672 5.879731 +3489 754 6 0 13.801680 -10.581422 -18.444834 +3490 754 4 0 14.024633 -10.709852 -17.519503 +3491 754 4 0 14.526918 -10.713699 -19.015218 +3492 755 6 0 -26.491618 -8.486894 -15.884962 +3493 755 4 0 -26.227094 -9.167912 -16.481603 +3494 755 4 0 -27.254427 -8.747438 -15.427464 +3495 756 6 0 9.041006 -18.956744 11.010081 +3496 756 4 0 9.242427 -19.133960 10.087876 +3497 756 4 0 9.841718 -19.136012 11.534074 +3498 757 6 0 -14.427557 4.070601 -15.330760 +3499 757 4 0 -14.952347 4.033207 -14.554014 +3500 757 4 0 -14.812926 4.741427 -15.800456 +3501 758 6 0 17.060580 -3.941095 -20.977244 +3502 758 4 0 17.749250 -4.204310 -20.329442 +3503 758 4 0 16.300042 -3.942896 -20.427486 +3504 759 6 0 -23.014194 6.362529 14.192538 +3505 759 4 0 -23.324814 5.470443 14.451595 +3506 759 4 0 -22.082482 6.279068 14.241974 +3507 760 6 0 -25.628726 -6.961569 -2.257843 +3508 760 4 0 -25.574604 -7.184504 -1.341207 +3509 760 4 0 -26.582064 -6.786831 -2.353726 +3510 761 6 0 22.564240 2.932310 -9.807597 +3511 761 4 0 23.151969 3.604785 -10.163343 +3512 761 4 0 22.874635 2.102350 -10.219491 +3513 762 6 0 -3.253479 19.088800 -17.106412 +3514 762 4 0 -2.788864 19.318234 -16.243589 +3515 762 4 0 -2.764381 19.537649 -17.806531 +3516 763 6 0 -22.859061 13.661040 -17.687912 +3517 763 4 0 -22.818174 13.783386 -16.772102 +3518 763 4 0 -23.770832 13.543351 -17.918472 +3519 764 6 0 9.494782 -11.734449 -13.112549 +3520 764 4 0 8.961400 -12.465267 -13.446468 +3521 764 4 0 9.761388 -11.207603 -13.875868 +3522 765 6 0 -23.688259 3.132799 -17.827915 +3523 765 4 0 -24.125760 3.978960 -17.963214 +3524 765 4 0 -22.830341 3.138251 -18.271402 +3525 766 6 0 2.139153 19.832776 -5.462308 +3526 766 4 0 3.092901 19.927439 -5.794969 +3527 766 4 0 1.766619 18.977669 -5.658347 +3528 767 6 0 -18.034230 16.770127 14.099225 +3529 767 4 0 -17.902225 17.120236 14.993829 +3530 767 4 0 -17.676323 15.854045 14.106616 +3531 768 6 0 1.824513 11.181132 6.084313 +3532 768 4 0 1.685221 10.344866 6.529341 +3533 768 4 0 1.455718 11.848001 6.661967 +3534 769 6 0 -11.843291 -5.056449 -16.641604 +3535 769 4 0 -12.501020 -5.242103 -17.328702 +3536 769 4 0 -12.014281 -5.753377 -15.968200 +3537 770 6 0 -22.854164 5.542584 7.008128 +3538 770 4 0 -23.145262 4.706955 7.372586 +3539 770 4 0 -23.371620 6.215233 7.454255 +3540 771 6 0 15.073774 -20.411976 -0.392431 +3541 771 4 0 14.408322 -20.469017 0.286083 +3542 771 4 0 14.632572 -19.889979 -1.049199 +3543 772 6 0 -17.960070 -5.852749 5.689988 +3544 772 4 0 -18.090795 -5.039390 5.186397 +3545 772 4 0 -18.353234 -5.775538 6.579834 +3546 773 6 0 -15.352248 -19.036717 0.344261 +3547 773 4 0 -15.093308 -18.197320 -0.050384 +3548 773 4 0 -15.225898 -18.950231 1.302869 +3549 774 6 0 18.470960 -18.740483 5.244443 +3550 774 4 0 18.242618 -17.821184 5.079689 +3551 774 4 0 19.343394 -18.632602 5.657266 +3552 775 6 0 -20.494949 -15.508798 0.415196 +3553 775 4 0 -21.033257 -14.800381 0.873351 +3554 775 4 0 -20.631551 -16.381502 0.919462 +3555 776 6 0 -26.836213 -15.820962 -1.291434 +3556 776 4 0 -25.922353 -15.963173 -1.047747 +3557 776 4 0 -27.438259 -16.224400 -0.574562 +3558 777 6 0 -13.235942 4.403119 -11.675233 +3559 777 4 0 -12.394934 3.955397 -11.762629 +3560 777 4 0 -13.370313 4.660640 -10.729304 +3561 778 6 0 4.457457 8.304220 -12.786971 +3562 778 4 0 3.724242 8.788507 -13.141101 +3563 778 4 0 4.902410 9.007385 -12.278991 +3564 779 6 0 12.905103 9.611740 -9.761522 +3565 779 4 0 12.523788 8.903277 -10.260068 +3566 779 4 0 13.450668 9.299611 -9.028515 +3567 780 6 0 -6.337643 16.236433 1.452793 +3568 780 4 0 -5.424381 16.339480 1.573225 +3569 780 4 0 -6.667968 16.644895 2.291271 +3570 781 6 0 26.439116 -1.915810 -20.713552 +3571 781 4 0 27.188632 -1.287536 -20.817388 +3572 781 4 0 26.782485 -2.730706 -20.995261 +3573 782 6 0 -19.182622 4.092355 9.034920 +3574 782 4 0 -19.485362 4.670885 8.308243 +3575 782 4 0 -20.013187 3.814515 9.521856 +3576 783 6 0 -2.300541 3.557512 -14.043398 +3577 783 4 0 -1.431422 3.599599 -13.555115 +3578 783 4 0 -1.988145 3.224630 -14.961052 +3579 784 6 0 -6.670819 -15.218721 -14.514642 +3580 784 4 0 -6.017795 -15.980959 -14.424699 +3581 784 4 0 -6.265671 -14.423752 -14.172913 +3582 785 6 0 24.507006 4.960415 18.725868 +3583 785 4 0 24.051892 4.202462 19.172938 +3584 785 4 0 23.940639 5.744203 18.851669 +3585 786 6 0 24.049293 12.473043 -13.141226 +3586 786 4 0 23.243912 12.962673 -12.967339 +3587 786 4 0 23.840443 11.608716 -13.489633 +3588 787 6 0 -14.826342 -14.174711 -1.101280 +3589 787 4 0 -14.425942 -14.926791 -0.673989 +3590 787 4 0 -15.768151 -14.488595 -1.118329 +3591 788 6 0 11.933486 13.553808 -14.961215 +3592 788 4 0 11.036396 13.817670 -14.752407 +3593 788 4 0 12.216429 12.950104 -14.279104 +3594 789 6 0 -2.797562 -12.367574 -0.515800 +3595 789 4 0 -3.179634 -11.713519 0.050158 +3596 789 4 0 -1.854871 -12.532942 -0.270880 +3597 790 6 0 17.488207 19.028545 -2.724709 +3598 790 4 0 17.501182 19.646316 -1.945319 +3599 790 4 0 17.260989 19.579570 -3.517708 +3600 791 6 0 -8.757369 -14.229883 -8.206010 +3601 791 4 0 -8.893000 -13.537739 -8.862015 +3602 791 4 0 -9.392123 -14.135387 -7.486682 +3603 792 6 0 -19.153579 -12.365172 5.625409 +3604 792 4 0 -19.433383 -12.590110 4.725475 +3605 792 4 0 -19.595557 -11.555979 5.869535 +3606 793 6 0 -7.701926 -16.135625 -11.737971 +3607 793 4 0 -6.868196 -16.044745 -12.240387 +3608 793 4 0 -8.301809 -15.535544 -12.265120 +3609 794 6 0 -3.605808 12.358960 20.023921 +3610 794 4 0 -4.119307 12.832959 19.358309 +3611 794 4 0 -4.145218 11.656406 20.372183 +3612 795 6 0 -13.013980 18.377636 -12.951904 +3613 795 4 0 -12.288179 17.997337 -13.504982 +3614 795 4 0 -12.538318 18.992103 -12.385350 +3615 796 6 0 -1.385735 6.480272 7.505236 +3616 796 4 0 -1.829939 5.594981 7.333987 +3617 796 4 0 -1.326794 6.575998 8.446333 +3618 797 6 0 9.907861 10.609361 -15.151767 +3619 797 4 0 10.299023 10.375476 -14.276851 +3620 797 4 0 9.651161 11.529891 -14.985274 +3621 798 6 0 9.310538 -2.514250 -12.134416 +3622 798 4 0 10.198177 -2.553660 -11.653872 +3623 798 4 0 8.836792 -1.753472 -11.726830 +3624 799 6 0 -21.580142 4.778390 0.032360 +3625 799 4 0 -21.344591 5.531473 -0.492439 +3626 799 4 0 -20.893065 4.098475 -0.015753 +3627 800 6 0 -19.278441 10.667329 -7.670184 +3628 800 4 0 -19.734646 10.867025 -6.871193 +3629 800 4 0 -18.532328 10.061861 -7.412248 +3630 801 6 0 15.203902 17.401580 19.186703 +3631 801 4 0 15.570898 16.998223 18.309293 +3632 801 4 0 14.252264 17.471997 19.020983 +3633 802 6 0 17.475659 -4.241820 15.422666 +3634 802 4 0 17.040898 -4.071975 16.320909 +3635 802 4 0 18.352897 -4.517345 15.720235 +3636 803 6 0 26.262986 8.204965 -20.205701 +3637 803 4 0 26.293506 8.464866 -19.242230 +3638 803 4 0 25.312183 8.095575 -20.318886 +3639 804 6 0 0.327844 9.896832 15.417356 +3640 804 4 0 1.202524 9.685899 15.170065 +3641 804 4 0 -0.168717 9.349803 14.747140 +3642 805 6 0 13.450972 -1.248355 9.296159 +3643 805 4 0 12.530981 -1.651940 9.252801 +3644 805 4 0 13.953341 -1.912001 9.787602 +3645 806 6 0 -5.429467 -15.995612 -8.899753 +3646 806 4 0 -4.916725 -16.325409 -8.062672 +3647 806 4 0 -6.362549 -16.264748 -8.759990 +3648 807 6 0 -17.910357 -1.868084 -15.474085 +3649 807 4 0 -18.801800 -2.365773 -15.300107 +3650 807 4 0 -17.939036 -0.883951 -15.233581 +3651 808 6 0 -6.998449 17.854546 12.155260 +3652 808 4 0 -7.324766 18.684261 11.705842 +3653 808 4 0 -7.250338 17.940958 13.056006 +3654 809 6 0 -27.017579 -12.852914 -7.744953 +3655 809 4 0 -26.095216 -13.088941 -7.541719 +3656 809 4 0 -27.046015 -11.903607 -7.742366 +3657 810 6 0 -20.992952 2.770137 13.223137 +3658 810 4 0 -21.230776 2.404263 14.087077 +3659 810 4 0 -20.235470 2.326081 12.930982 +3660 811 6 0 -26.544599 -5.877011 11.453664 +3661 811 4 0 -26.990332 -6.544246 10.916058 +3662 811 4 0 -26.022394 -5.435999 10.830265 +3663 812 6 0 -18.806379 11.367507 -13.046200 +3664 812 4 0 -19.789015 11.313553 -13.067429 +3665 812 4 0 -18.628129 11.249318 -14.024506 +3666 813 6 0 24.794642 -2.429791 16.906929 +3667 813 4 0 24.375084 -1.564983 16.998802 +3668 813 4 0 24.946627 -2.558178 15.958491 +3669 814 6 0 -5.039569 8.056593 -19.064906 +3670 814 4 0 -5.052461 7.958795 -18.117466 +3671 814 4 0 -5.966890 7.849304 -19.446709 +3672 815 6 0 -2.889572 19.346856 10.223639 +3673 815 4 0 -3.384312 19.390763 9.401856 +3674 815 4 0 -2.683383 20.308050 10.287170 +3675 816 6 0 24.834396 15.890694 6.130456 +3676 816 4 0 24.234322 16.328808 6.788069 +3677 816 4 0 24.458399 16.070054 5.248361 +3678 817 6 0 -5.675815 -18.202610 8.635402 +3679 817 4 0 -5.773224 -18.994730 9.253066 +3680 817 4 0 -6.566693 -17.951332 8.462469 +3681 818 6 0 0.200228 10.638735 -9.720146 +3682 818 4 0 1.124053 10.363079 -9.765946 +3683 818 4 0 -0.169388 10.758518 -8.862327 +3684 819 6 0 12.586551 -8.995486 13.235948 +3685 819 4 0 11.738414 -8.465169 13.179917 +3686 819 4 0 13.275714 -8.448558 12.911108 +3687 820 6 0 21.728995 -9.340509 14.117203 +3688 820 4 0 21.166035 -8.543859 14.159733 +3689 820 4 0 21.300249 -10.103143 14.587027 +3690 821 6 0 -6.837755 -7.061822 -14.579566 +3691 821 4 0 -7.451539 -6.737549 -13.910594 +3692 821 4 0 -7.310401 -7.496795 -15.364575 +3693 822 6 0 -9.354286 -10.670675 -5.815047 +3694 822 4 0 -9.142443 -9.961054 -6.416990 +3695 822 4 0 -10.107132 -10.315463 -5.251791 +3696 823 6 0 -8.705352 0.316369 14.356920 +3697 823 4 0 -8.755318 1.248673 14.182151 +3698 823 4 0 -7.817961 -0.022395 14.313721 +3699 824 6 0 14.343736 18.982116 -1.699643 +3700 824 4 0 14.409424 19.286931 -2.586247 +3701 824 4 0 14.592964 19.709765 -1.190359 +3702 825 6 0 14.559527 1.138316 10.218417 +3703 825 4 0 15.479051 1.159830 9.856479 +3704 825 4 0 14.063855 0.416501 9.816078 +3705 826 6 0 -20.566241 -0.996254 13.005878 +3706 826 4 0 -20.899331 -1.479928 12.209922 +3707 826 4 0 -20.624473 -1.700653 13.673656 +3708 827 6 0 -12.852778 -16.278261 -7.915385 +3709 827 4 0 -13.264438 -16.542888 -8.750067 +3710 827 4 0 -12.112512 -16.948829 -7.782415 +3711 828 6 0 -25.785944 -19.319619 -1.839096 +3712 828 4 0 -26.458799 -18.855500 -2.342721 +3713 828 4 0 -25.985807 -19.145409 -0.929325 +3714 829 6 0 -10.186107 18.619821 1.502896 +3715 829 4 0 -10.024101 19.020438 2.390188 +3716 829 4 0 -10.942245 19.107400 1.164289 +3717 830 6 0 4.484858 10.819107 -17.964431 +3718 830 4 0 5.133939 11.386899 -18.298672 +3719 830 4 0 4.527691 10.727124 -17.013873 +3720 831 6 0 6.463933 -18.890881 -12.906574 +3721 831 4 0 7.142489 -18.893949 -12.181472 +3722 831 4 0 6.490763 -19.813219 -13.109192 +3723 832 6 0 -15.198788 -16.766626 -9.336110 +3724 832 4 0 -15.377180 -16.563167 -8.461513 +3725 832 4 0 -15.323254 -15.974257 -9.877497 +3726 833 6 0 -14.146010 -20.422548 8.878122 +3727 833 4 0 -14.236979 -20.532175 7.917793 +3728 833 4 0 -13.662828 -21.215449 9.131232 +3729 834 6 0 0.614957 1.428020 12.956126 +3730 834 4 0 -0.110540 1.901658 12.528670 +3731 834 4 0 0.325279 0.716474 13.497208 +3732 835 6 0 -22.321257 -12.194484 -18.427855 +3733 835 4 0 -22.696325 -13.106322 -18.375252 +3734 835 4 0 -22.412389 -11.917225 -19.335761 +3735 836 6 0 12.531442 -4.758462 20.472899 +3736 836 4 0 13.067534 -4.753926 21.307738 +3737 836 4 0 12.096556 -5.562360 20.454035 +3738 837 6 0 13.892356 14.515119 -17.220006 +3739 837 4 0 13.491013 15.249793 -17.676248 +3740 837 4 0 14.027899 14.819402 -16.306112 +3741 838 6 0 17.502120 -14.847049 -15.435947 +3742 838 4 0 17.364472 -13.948352 -15.811879 +3743 838 4 0 18.105027 -15.359005 -16.059699 +3744 839 6 0 -0.502268 9.530205 -15.562269 +3745 839 4 0 -0.938753 10.373293 -15.281955 +3746 839 4 0 -0.097702 9.138998 -14.755615 +3747 840 6 0 -21.309309 -20.408905 -16.987522 +3748 840 4 0 -21.345337 -20.375840 -17.999142 +3749 840 4 0 -22.141862 -20.762308 -16.688786 +3750 841 6 0 22.147493 -6.639909 2.885000 +3751 841 4 0 22.188652 -7.549798 2.578098 +3752 841 4 0 22.107229 -6.728348 3.871637 +3753 842 6 0 -9.687279 5.414380 15.613331 +3754 842 4 0 -9.782742 5.066486 16.529208 +3755 842 4 0 -10.448969 5.923644 15.361474 +3756 843 6 0 5.675344 7.586899 16.980957 +3757 843 4 0 5.258959 7.810456 16.122506 +3758 843 4 0 6.513311 8.070410 16.991766 +3759 844 6 0 -20.413973 -2.810756 -14.704675 +3760 844 4 0 -20.680710 -3.455276 -14.087899 +3761 844 4 0 -20.927913 -2.006038 -14.605374 +3762 845 6 0 -22.235897 -8.299273 -7.619662 +3763 845 4 0 -22.889194 -7.882281 -8.261122 +3764 845 4 0 -22.332627 -7.861076 -6.765324 +3765 846 6 0 -23.981218 -0.704780 -9.514827 +3766 846 4 0 -24.783483 -0.715849 -8.978342 +3767 846 4 0 -24.016239 0.147898 -9.927153 +3768 847 6 0 7.651613 1.583143 -14.760840 +3769 847 4 0 8.495812 1.439050 -15.299970 +3770 847 4 0 7.511620 2.516131 -14.862425 +3771 848 6 0 0.884173 -19.810112 -4.062624 +3772 848 4 0 1.292889 -20.586437 -4.551786 +3773 848 4 0 1.192078 -19.022801 -4.536111 +3774 849 6 0 7.412040 11.115702 19.231433 +3775 849 4 0 7.538580 12.059258 19.246795 +3776 849 4 0 8.260401 10.691591 19.301522 +3777 850 6 0 -11.204219 12.495567 -4.600276 +3778 850 4 0 -11.028750 12.509428 -5.556334 +3779 850 4 0 -10.363635 12.791820 -4.218009 +3780 851 6 0 -25.903206 -8.385161 -5.723268 +3781 851 4 0 -25.119970 -7.920015 -6.092411 +3782 851 4 0 -25.526651 -8.874179 -5.022568 +3783 852 6 0 14.802024 4.590987 3.933454 +3784 852 4 0 14.375737 4.043905 3.277970 +3785 852 4 0 15.659394 4.916121 3.578549 +3786 853 6 0 -15.934931 6.397950 6.388644 +3787 853 4 0 -15.620802 7.216906 6.047813 +3788 853 4 0 -15.636175 5.690485 5.842853 +3789 854 6 0 22.212269 -3.912264 -1.134049 +3790 854 4 0 22.458591 -3.040474 -1.407870 +3791 854 4 0 22.479085 -3.998208 -0.233468 +3792 855 6 0 4.448770 -18.623307 6.143091 +3793 855 4 0 3.859811 -18.031485 6.593889 +3794 855 4 0 4.151476 -19.464236 6.536017 +3795 856 6 0 12.429816 -18.121512 9.248186 +3796 856 4 0 11.629942 -18.388099 8.814270 +3797 856 4 0 12.215561 -17.727680 10.120763 +3798 857 6 0 -8.497823 15.258872 16.966673 +3799 857 4 0 -7.810852 14.986731 16.348784 +3800 857 4 0 -8.167882 16.114306 17.249722 +3801 858 6 0 -20.878291 -14.745638 19.779655 +3802 858 4 0 -20.112590 -15.386225 19.796245 +3803 858 4 0 -20.957585 -14.429386 20.699068 +3804 859 6 0 -8.042069 13.212107 -6.799126 +3805 859 4 0 -7.666844 14.065367 -7.020588 +3806 859 4 0 -8.432360 12.994260 -7.617112 +3807 860 6 0 -4.401745 18.792233 12.536049 +3808 860 4 0 -5.252264 18.441661 12.206342 +3809 860 4 0 -3.786314 18.658531 11.783750 +3810 861 6 0 -22.502948 12.635671 -9.954592 +3811 861 4 0 -22.382976 11.654218 -10.023557 +3812 861 4 0 -22.588936 12.849370 -9.051340 +3813 862 6 0 6.205019 19.677761 10.016183 +3814 862 4 0 6.418256 20.244108 9.256973 +3815 862 4 0 6.081289 20.311217 10.773751 +3816 863 6 0 21.525435 -20.385383 2.444412 +3817 863 4 0 21.737318 -20.408572 1.494251 +3818 863 4 0 22.084053 -21.109629 2.761837 +3819 864 6 0 -16.599942 -18.820535 17.198669 +3820 864 4 0 -16.278472 -18.736077 16.290240 +3821 864 4 0 -16.380933 -19.763878 17.294110 +3822 865 6 0 -25.290808 -16.946358 -19.688799 +3823 865 4 0 -24.765600 -16.889073 -18.911085 +3824 865 4 0 -25.960541 -16.377910 -19.456590 +3825 866 6 0 -24.694098 -20.476906 -4.136770 +3826 866 4 0 -24.606655 -20.536372 -5.117234 +3827 866 4 0 -25.625806 -20.119370 -3.878957 +3828 867 6 0 11.896824 11.712030 16.306177 +3829 867 4 0 11.348704 12.251154 16.873688 +3830 867 4 0 11.274914 11.545841 15.498058 +3831 868 6 0 5.697623 16.972820 10.470297 +3832 868 4 0 4.991770 17.170798 11.097893 +3833 868 4 0 5.852878 17.817924 10.052784 +3834 869 6 0 -13.284850 -7.746454 -6.025360 +3835 869 4 0 -12.994189 -6.883337 -5.651840 +3836 869 4 0 -13.328473 -7.609512 -6.952585 +3837 870 6 0 -21.223162 1.160412 -11.807882 +3838 870 4 0 -22.146291 1.276713 -11.566889 +3839 870 4 0 -20.896068 1.043394 -10.863664 +3840 871 6 0 -4.631057 18.622729 -4.921244 +3841 871 4 0 -4.887844 18.863646 -4.031199 +3842 871 4 0 -5.230286 17.969756 -5.219284 +3843 872 6 0 24.681797 -17.654294 -1.670971 +3844 872 4 0 23.768274 -17.475294 -1.329114 +3845 872 4 0 24.791039 -18.602540 -1.565321 +3846 873 6 0 -17.687536 -19.879421 -18.679576 +3847 873 4 0 -17.986562 -20.092647 -17.773622 +3848 873 4 0 -17.222303 -20.676328 -18.924760 +3849 874 6 0 -6.573668 -1.414933 -12.940464 +3850 874 4 0 -5.981594 -0.685726 -13.202528 +3851 874 4 0 -7.313339 -1.430989 -13.600227 +3852 875 6 0 24.852405 8.745112 16.566019 +3853 875 4 0 25.315387 9.320408 17.189845 +3854 875 4 0 25.373490 7.938156 16.494188 +3855 876 6 0 19.231159 -18.894566 -9.451949 +3856 876 4 0 18.429507 -18.461081 -9.748217 +3857 876 4 0 18.920766 -19.499725 -8.784679 +3858 877 6 0 3.338073 -20.229490 -19.454945 +3859 877 4 0 2.656040 -19.781393 -18.876483 +3860 877 4 0 4.028693 -19.592026 -19.519704 +3861 878 6 0 10.225819 20.337141 12.829025 +3862 878 4 0 9.563839 20.833795 13.325284 +3863 878 4 0 9.705679 19.640109 12.367009 +3864 879 6 0 9.533934 0.668964 -16.571520 +3865 879 4 0 10.399193 0.538209 -16.091711 +3866 879 4 0 9.576351 1.385138 -17.298275 +3867 880 6 0 10.662383 -1.197996 9.643694 +3868 880 4 0 10.669217 -0.519470 10.302977 +3869 880 4 0 9.975986 -0.906856 8.995989 +3870 881 6 0 -8.631045 -16.685206 -9.233119 +3871 881 4 0 -8.853335 -15.836492 -8.694578 +3872 881 4 0 -8.361803 -16.344073 -10.088388 +3873 882 6 0 -16.046867 3.202795 -18.808362 +3874 882 4 0 -16.950450 3.324347 -19.009457 +3875 882 4 0 -16.106623 2.648826 -18.004784 +3876 883 6 0 -21.655953 -18.268305 -5.022876 +3877 883 4 0 -22.220521 -18.292491 -4.188932 +3878 883 4 0 -21.437192 -17.347868 -5.235461 +3879 884 6 0 -3.054479 -8.582825 -16.474970 +3880 884 4 0 -3.561388 -8.760643 -15.715699 +3881 884 4 0 -3.058659 -7.559442 -16.547327 +3882 885 6 0 -22.812267 -16.888527 -8.744475 +3883 885 4 0 -22.235942 -16.090582 -8.825879 +3884 885 4 0 -23.719738 -16.520887 -8.878128 +3885 886 6 0 -3.704190 -14.195133 -2.407699 +3886 886 4 0 -3.387102 -14.174810 -3.288821 +3887 886 4 0 -3.356349 -13.453995 -1.933962 +3888 887 6 0 -20.696165 -13.591009 17.258237 +3889 887 4 0 -21.475297 -13.153296 16.960866 +3890 887 4 0 -20.768473 -13.524910 18.211894 +3891 888 6 0 -18.077515 8.036142 -4.047377 +3892 888 4 0 -17.812789 8.648744 -4.737838 +3893 888 4 0 -17.620887 8.520879 -3.289746 +3894 889 6 0 -20.110600 19.407267 6.124785 +3895 889 4 0 -20.896902 18.868688 6.157232 +3896 889 4 0 -20.402600 20.334320 6.077069 +3897 890 6 0 -2.051195 9.467924 7.827905 +3898 890 4 0 -2.097838 10.162479 7.064246 +3899 890 4 0 -2.844983 9.344092 8.305687 +3900 891 6 0 -18.682154 5.478699 -2.934427 +3901 891 4 0 -18.229636 5.442492 -2.124369 +3902 891 4 0 -18.518659 6.286464 -3.381696 +3903 892 6 0 10.010203 14.447632 13.470001 +3904 892 4 0 10.226696 15.357421 13.799091 +3905 892 4 0 9.262668 14.599091 12.884669 +3906 893 6 0 17.215836 -17.548329 -2.124086 +3907 893 4 0 16.925189 -16.662250 -2.252230 +3908 893 4 0 16.865887 -17.769074 -1.235796 +3909 894 6 0 -5.919183 -9.349524 7.766171 +3910 894 4 0 -6.741218 -8.869400 7.859192 +3911 894 4 0 -5.404573 -8.951408 7.082536 +3912 895 6 0 -10.112774 -17.514245 5.470012 +3913 895 4 0 -10.177248 -17.335797 6.413035 +3914 895 4 0 -10.903396 -17.912916 5.176788 +3915 896 6 0 -17.679442 -12.718669 -9.050443 +3916 896 4 0 -18.270476 -12.557016 -8.300034 +3917 896 4 0 -18.198469 -12.552825 -9.805697 +3918 897 6 0 0.903259 -17.089060 -20.671596 +3919 897 4 0 1.071535 -16.725461 -21.579419 +3920 897 4 0 1.485989 -16.556142 -20.071022 +3921 898 6 0 -1.956506 2.203046 13.006137 +3922 898 4 0 -2.272231 1.835920 13.818085 +3923 898 4 0 -1.592679 3.074581 13.177858 +3924 899 6 0 24.307317 -7.931160 13.942533 +3925 899 4 0 23.816648 -8.756525 14.130421 +3926 899 4 0 25.262169 -8.082231 14.204005 +3927 900 6 0 -14.058968 19.300765 0.314297 +3928 900 4 0 -13.917031 18.387642 0.266006 +3929 900 4 0 -13.221511 19.754514 0.415523 +3930 901 6 0 -16.676872 -9.877858 -20.319129 +3931 901 4 0 -17.274810 -10.519927 -20.729021 +3932 901 4 0 -16.941519 -8.964879 -20.646570 +3933 902 6 0 -12.680702 -6.911233 16.978199 +3934 902 4 0 -13.557850 -6.922758 17.425905 +3935 902 4 0 -12.269134 -7.738029 17.145620 +3936 903 6 0 19.555509 -17.579926 -19.976313 +3937 903 4 0 19.050335 -18.389167 -19.640518 +3938 903 4 0 18.949443 -17.119931 -20.527020 +3939 904 6 0 21.076471 3.084534 14.949703 +3940 904 4 0 21.982711 3.424585 15.137726 +3941 904 4 0 21.059338 2.943234 13.989445 +3942 905 6 0 16.442213 12.147725 -13.378964 +3943 905 4 0 16.950297 12.610197 -12.695317 +3944 905 4 0 15.827762 12.795203 -13.746701 +3945 906 6 0 -25.439902 4.711302 -20.157995 +3946 906 4 0 -25.232468 3.814757 -20.523590 +3947 906 4 0 -26.313293 4.971364 -20.426324 +3948 907 6 0 -7.588528 12.088664 13.408162 +3949 907 4 0 -8.200423 12.174754 12.658025 +3950 907 4 0 -8.113691 11.630720 14.142990 +3951 908 6 0 26.436785 0.034911 5.586573 +3952 908 4 0 25.457878 0.386547 5.643112 +3953 908 4 0 26.282513 -0.892272 5.901143 +3954 909 6 0 20.823937 -7.100912 -0.564869 +3955 909 4 0 20.884805 -6.179294 -0.203608 +3956 909 4 0 21.513466 -7.607628 -0.095760 +3957 910 6 0 12.691400 17.480587 1.380786 +3958 910 4 0 12.692396 17.261428 2.322353 +3959 910 4 0 12.611923 16.651984 0.923905 +3960 911 6 0 -24.911725 10.197954 8.411953 +3961 911 4 0 -25.636701 10.762551 8.096402 +3962 911 4 0 -25.071847 10.060147 9.332683 +3963 912 6 0 -18.639378 5.447813 -18.001661 +3964 912 4 0 -18.974361 6.320483 -18.277153 +3965 912 4 0 -17.987263 5.631149 -17.283273 +3966 913 6 0 -20.959865 -1.961151 19.496385 +3967 913 4 0 -20.534023 -2.468481 20.215248 +3968 913 4 0 -20.355179 -1.361709 19.053432 +3969 914 6 0 25.098062 -12.896695 17.002170 +3970 914 4 0 24.406639 -13.455503 17.206622 +3971 914 4 0 24.932322 -12.540708 16.110034 +3972 915 6 0 -26.490917 -20.588542 6.528398 +3973 915 4 0 -26.917008 -20.096913 5.823633 +3974 915 4 0 -25.946103 -19.813146 6.884354 +3975 916 6 0 18.663882 -15.761448 0.434559 +3976 916 4 0 18.293356 -16.602715 0.618971 +3977 916 4 0 18.164755 -15.050245 0.892557 +3978 917 6 0 10.988074 -12.207500 15.456319 +3979 917 4 0 11.659991 -12.535619 14.945024 +3980 917 4 0 11.316489 -11.864883 16.268157 +3981 918 6 0 -21.505805 3.757682 10.585783 +3982 918 4 0 -21.516645 3.500786 11.561155 +3983 918 4 0 -21.430683 4.736521 10.599986 +3984 919 6 0 12.282284 -13.106227 -18.881930 +3985 919 4 0 12.759593 -12.281589 -18.973554 +3986 919 4 0 11.656222 -12.946682 -18.168338 +3987 920 6 0 13.087944 10.285301 -0.892868 +3988 920 4 0 13.800763 10.058844 -0.348329 +3989 920 4 0 13.444993 10.532975 -1.717057 +3990 921 6 0 -9.162139 -11.933739 -19.558277 +3991 921 4 0 -8.651549 -11.246835 -19.197918 +3992 921 4 0 -8.816392 -12.749175 -19.109531 +3993 922 6 0 -13.431343 12.125781 14.789987 +3994 922 4 0 -14.177333 12.077783 15.386597 +3995 922 4 0 -13.089871 13.025037 14.836795 +3996 923 6 0 18.177368 7.215321 -17.740007 +3997 923 4 0 17.389540 7.853045 -17.679076 +3998 923 4 0 17.843221 6.367105 -17.888163 +3999 924 6 0 1.466167 -13.601298 7.582198 +4000 924 4 0 0.972435 -14.385853 7.776388 +4001 924 4 0 0.919057 -12.873156 7.164133 +4002 925 6 0 11.325663 12.317782 -17.859494 +4003 925 4 0 11.786996 12.918180 -17.243704 +4004 925 4 0 11.714407 11.538450 -17.534509 +4005 926 6 0 17.972713 -1.451543 -17.483151 +4006 926 4 0 18.207855 -0.912662 -18.203981 +4007 926 4 0 17.842338 -0.769611 -16.779012 +4008 927 6 0 25.598333 7.442585 -7.896359 +4009 927 4 0 25.893540 7.973241 -8.686847 +4010 927 4 0 24.662621 7.579298 -7.748832 +4011 928 6 0 16.953262 -5.516556 7.796955 +4012 928 4 0 16.150883 -6.127947 7.920888 +4013 928 4 0 16.872953 -4.676742 8.219748 +4014 929 6 0 12.447806 -2.742404 -5.103683 +4015 929 4 0 13.262065 -2.337192 -4.865615 +4016 929 4 0 12.567802 -3.638206 -5.489980 +4017 930 6 0 23.442824 1.912863 -4.186751 +4018 930 4 0 22.783687 1.609227 -4.831788 +4019 930 4 0 23.692291 2.783304 -4.548967 +4020 931 6 0 26.613065 -7.057291 -2.847144 +4021 931 4 0 25.921057 -6.884909 -2.189136 +4022 931 4 0 26.624480 -6.286981 -3.475448 +4023 932 6 0 -10.239445 -6.332791 -18.742073 +4024 932 4 0 -10.340169 -5.647767 -18.098924 +4025 932 4 0 -10.090969 -5.968696 -19.646250 +4026 933 6 0 -20.376403 -6.492157 -15.200035 +4027 933 4 0 -21.216096 -6.709010 -14.741818 +4028 933 4 0 -19.747585 -6.443291 -14.454302 +4029 934 6 0 12.425316 -12.073259 9.372568 +4030 934 4 0 12.595386 -11.730652 10.279050 +4031 934 4 0 11.975580 -11.375801 8.874658 +4032 935 6 0 -8.532199 -0.531892 16.952480 +4033 935 4 0 -8.680978 0.164546 17.584693 +4034 935 4 0 -8.601294 -0.093174 16.091071 +4035 936 6 0 -15.814683 -10.863297 -17.898155 +4036 936 4 0 -15.883461 -10.639190 -18.879894 +4037 936 4 0 -16.703278 -10.849248 -17.497731 +4038 937 6 0 -14.449801 9.759702 -12.925291 +4039 937 4 0 -14.272437 8.788361 -12.976539 +4040 937 4 0 -15.016657 9.891030 -12.180657 +4041 938 6 0 -21.430732 11.921106 -19.181002 +4042 938 4 0 -21.526880 12.138660 -20.109451 +4043 938 4 0 -22.050688 12.479567 -18.617821 +4044 939 6 0 -25.974066 -3.158098 2.462777 +4045 939 4 0 -25.831369 -2.255405 2.174801 +4046 939 4 0 -26.439926 -3.064742 3.263507 +4047 940 6 0 -3.706735 6.147388 -13.605663 +4048 940 4 0 -3.297323 5.307884 -13.886877 +4049 940 4 0 -3.422860 6.737980 -14.321183 +4050 941 6 0 -20.883597 16.612287 14.041958 +4051 941 4 0 -20.999564 17.543929 13.958831 +4052 941 4 0 -19.965627 16.487176 14.039107 +4053 942 6 0 -20.557889 -1.845471 7.488592 +4054 942 4 0 -20.340337 -1.068424 6.935483 +4055 942 4 0 -20.903185 -2.604394 7.012639 +4056 943 6 0 -12.460264 -18.929249 4.382660 +4057 943 4 0 -12.282133 -18.769615 3.435033 +4058 943 4 0 -13.389343 -18.666156 4.432821 +4059 944 6 0 1.417248 11.708889 10.582961 +4060 944 4 0 2.296023 11.794703 10.114913 +4061 944 4 0 1.322165 12.680869 10.895877 +4062 945 6 0 10.022181 17.152306 -1.509079 +4063 945 4 0 9.099220 16.788088 -1.473811 +4064 945 4 0 10.556572 16.462293 -1.005697 +4065 946 6 0 26.377298 1.167852 -18.114945 +4066 946 4 0 26.294922 1.597527 -19.017371 +4067 946 4 0 26.810582 1.835218 -17.546811 +4068 947 6 0 4.477282 16.231872 -2.892567 +4069 947 4 0 4.601255 15.878653 -3.817385 +4070 947 4 0 5.378487 16.115183 -2.438618 +4071 948 6 0 24.364511 -2.064551 14.086212 +4072 948 4 0 24.217903 -1.193238 13.665466 +4073 948 4 0 25.144037 -2.400521 13.646565 +4074 949 6 0 19.972396 19.003953 10.129446 +4075 949 4 0 19.099910 19.391464 10.278245 +4076 949 4 0 20.140306 18.289889 10.813702 +4077 950 6 0 -9.744468 15.055459 -16.611544 +4078 950 4 0 -10.467454 15.614656 -16.286228 +4079 950 4 0 -10.073803 14.402676 -17.210684 +4080 951 6 0 -7.338670 -8.956276 -11.936725 +4081 951 4 0 -7.205180 -9.461193 -11.112425 +4082 951 4 0 -8.291268 -8.840677 -12.000288 +4083 952 6 0 9.310332 14.156142 -6.279488 +4084 952 4 0 10.218649 13.951492 -6.545390 +4085 952 4 0 9.258047 14.553265 -5.370592 +4086 953 6 0 0.560208 -13.174622 -9.781962 +4087 953 4 0 0.439761 -12.748376 -10.646076 +4088 953 4 0 0.670280 -14.103731 -9.913873 +4089 954 6 0 26.128167 14.199294 -1.068870 +4090 954 4 0 26.431992 13.452397 -0.460937 +4091 954 4 0 25.201007 14.292566 -1.045597 +4092 955 6 0 -16.949107 1.727945 -4.563937 +4093 955 4 0 -16.652995 1.770027 -5.488123 +4094 955 4 0 -17.803051 2.243334 -4.537865 +4095 956 6 0 -11.599049 -20.904475 0.385428 +4096 956 4 0 -11.617180 -19.974350 0.739051 +4097 956 4 0 -10.733402 -20.802194 -0.016961 +4098 957 6 0 -25.256117 12.394753 17.084014 +4099 957 4 0 -24.597187 12.955531 17.523929 +4100 957 4 0 -25.351341 11.801006 17.816577 +4101 958 6 0 21.083077 10.997597 -6.264609 +4102 958 4 0 20.914438 11.935561 -6.410001 +4103 958 4 0 20.611065 10.573853 -6.944918 +4104 959 6 0 24.363484 -19.776402 17.065120 +4105 959 4 0 24.744693 -19.074320 16.551577 +4106 959 4 0 25.036878 -20.294208 17.436608 +4107 960 6 0 -10.735684 9.638082 6.150386 +4108 960 4 0 -10.221167 9.463561 5.360913 +4109 960 4 0 -11.618988 9.902798 5.921573 +4110 961 6 0 -14.186781 2.877388 6.286661 +4111 961 4 0 -14.662769 3.118087 7.092293 +4112 961 4 0 -14.425510 3.607015 5.695311 +4113 962 6 0 23.488790 -12.140879 -16.710373 +4114 962 4 0 23.035645 -11.840916 -17.492726 +4115 962 4 0 24.198140 -11.533887 -16.669370 +4116 963 6 0 -9.756394 20.612891 7.487522 +4117 963 4 0 -10.567829 20.596149 6.941769 +4118 963 4 0 -9.567427 19.672366 7.650269 +4119 964 6 0 -10.809623 -15.325182 16.646046 +4120 964 4 0 -10.540345 -15.380934 15.754906 +4121 964 4 0 -10.995048 -16.212302 17.003558 +4122 965 6 0 23.590175 -14.844140 18.091313 +4123 965 4 0 23.082950 -15.642639 17.817614 +4124 965 4 0 22.918432 -14.433938 18.680116 +4125 966 6 0 -9.843301 16.099124 8.917553 +4126 966 4 0 -10.800912 15.942477 8.746196 +4127 966 4 0 -9.776206 16.007775 9.870062 +4128 967 6 0 -15.969686 15.153089 5.232592 +4129 967 4 0 -15.190596 15.577230 4.796399 +4130 967 4 0 -16.653218 15.791665 5.086615 +4131 968 6 0 -14.522038 4.774109 20.092720 +4132 968 4 0 -13.726552 4.726517 19.600040 +4133 968 4 0 -14.275341 5.232921 20.890928 +4134 969 6 0 -19.150467 -13.472817 -2.000864 +4135 969 4 0 -19.948375 -14.097323 -2.133949 +4136 969 4 0 -18.565882 -13.718795 -2.719742 +4137 970 6 0 26.570568 3.571434 2.677152 +4138 970 4 0 26.009960 3.474978 1.867261 +4139 970 4 0 25.979473 4.132392 3.254985 +4140 971 6 0 2.963742 -20.267378 17.680551 +4141 971 4 0 2.939273 -19.702759 18.451804 +4142 971 4 0 3.704894 -20.009537 17.129551 +4143 972 6 0 12.886914 -16.854820 -15.969948 +4144 972 4 0 13.277380 -15.998244 -16.290560 +4145 972 4 0 12.084202 -16.946569 -16.485310 +4146 973 6 0 -13.403098 20.670706 14.180090 +4147 973 4 0 -12.697115 20.129500 13.825532 +4148 973 4 0 -13.078241 21.562186 14.353615 +4149 974 6 0 1.263724 -2.316623 11.541630 +4150 974 4 0 1.604989 -3.147382 11.057854 +4151 974 4 0 1.301508 -2.419331 12.514250 +4152 975 6 0 16.027424 -2.901060 -7.834089 +4153 975 4 0 15.527925 -3.644628 -8.229138 +4154 975 4 0 15.964477 -2.241942 -8.584411 +4155 976 6 0 20.574908 7.015109 -16.355513 +4156 976 4 0 20.799767 7.912603 -16.672696 +4157 976 4 0 19.614717 7.020855 -16.464707 +4158 977 6 0 -9.799678 -16.315433 -2.735469 +4159 977 4 0 -9.082163 -15.876270 -3.158920 +4160 977 4 0 -9.675027 -17.234496 -2.912849 +4161 978 6 0 19.925358 -1.799248 -13.616500 +4162 978 4 0 19.041533 -1.607762 -13.949745 +4163 978 4 0 20.105803 -1.002750 -13.099573 +4164 979 6 0 26.502531 14.202393 -14.528425 +4165 979 4 0 25.566109 14.188457 -14.685868 +4166 979 4 0 26.586381 14.616670 -13.692642 +4167 980 6 0 -3.640972 -15.964509 3.441932 +4168 980 4 0 -3.916866 -16.633969 4.049731 +4169 980 4 0 -3.180242 -16.493582 2.755249 +4170 981 6 0 20.157853 -15.783144 2.660570 +4171 981 4 0 20.419750 -16.681495 2.950489 +4172 981 4 0 19.984795 -15.805827 1.709836 +4173 982 6 0 3.128568 11.959447 -14.685598 +4174 982 4 0 2.607191 12.662191 -15.102263 +4175 982 4 0 3.769283 12.428495 -14.079944 +4176 983 6 0 -24.815536 -15.542873 4.007555 +4177 983 4 0 -24.218085 -16.000016 3.406953 +4178 983 4 0 -25.315854 -15.091766 3.403899 +4179 984 6 0 19.308952 20.661672 -11.377272 +4180 984 4 0 19.335667 21.503703 -10.905560 +4181 984 4 0 20.214980 20.602723 -11.631713 +4182 985 6 0 13.542822 -5.649499 0.333332 +4183 985 4 0 13.963629 -4.763289 0.274336 +4184 985 4 0 12.814580 -5.810940 -0.269097 +4185 986 6 0 13.690049 -20.143279 -5.943461 +4186 986 4 0 13.436356 -20.544177 -6.811045 +4187 986 4 0 14.540599 -19.746894 -6.080417 +4188 987 6 0 -15.552613 1.765055 -16.570745 +4189 987 4 0 -15.053582 2.345281 -15.988522 +4190 987 4 0 -15.170829 0.889200 -16.752662 +4191 988 6 0 18.304944 6.143260 -6.070829 +4192 988 4 0 18.125046 5.326107 -5.570747 +4193 988 4 0 18.266448 6.784180 -5.360045 +4194 989 6 0 2.506981 -17.274997 10.100766 +4195 989 4 0 3.347828 -17.659592 10.064456 +4196 989 4 0 2.856471 -16.401034 10.442415 +4197 990 6 0 -19.165460 9.947070 1.363209 +4198 990 4 0 -18.730236 10.366229 0.602857 +4199 990 4 0 -18.849961 10.481480 2.151944 +4200 991 6 0 -25.980688 17.933161 -0.316559 +4201 991 4 0 -26.443527 17.228913 -0.781861 +4202 991 4 0 -25.367896 18.145268 -0.998602 +4203 992 6 0 -8.979352 -14.825818 -16.044347 +4204 992 4 0 -8.232685 -15.013438 -15.478412 +4205 992 4 0 -9.593300 -15.565144 -15.856307 +4206 993 6 0 -26.878522 10.651550 -5.997590 +4207 993 4 0 -27.657923 11.080372 -6.414692 +4208 993 4 0 -26.575102 11.315809 -5.418717 +4209 994 6 0 25.946197 20.187421 -17.138659 +4210 994 4 0 26.747885 20.729551 -17.283461 +4211 994 4 0 25.893413 20.171520 -16.172728 +4212 995 6 0 -22.758506 -11.646357 10.203824 +4213 995 4 0 -22.294597 -11.119698 9.558550 +4214 995 4 0 -22.038786 -12.335635 10.328914 +4215 996 6 0 5.051118 -7.506736 -18.096705 +4216 996 4 0 5.890399 -6.995469 -18.089124 +4217 996 4 0 4.432798 -7.081744 -18.676680 +4218 997 6 0 -25.361275 -6.967887 -18.797135 +4219 997 4 0 -24.723765 -6.707007 -18.115496 +4220 997 4 0 -25.259315 -7.901704 -18.865340 +4221 998 6 0 -2.799085 -16.680409 -5.658803 +4222 998 4 0 -3.041668 -16.532466 -4.707237 +4223 998 4 0 -2.655725 -17.646573 -5.729646 +4224 999 6 0 6.961841 -0.650018 14.982518 +4225 999 4 0 7.049840 -0.822572 15.899427 +4226 999 4 0 7.585417 -1.245556 14.495279 +4227 1000 6 0 -27.328225 -2.775920 4.654966 +4228 1000 4 0 -28.131668 -3.256883 4.960696 +4229 1000 4 0 -26.702154 -2.749977 5.390082 +4230 1001 6 0 -10.545176 15.887401 -11.516094 +4231 1001 4 0 -11.354652 16.437925 -11.631152 +4232 1001 4 0 -10.234139 15.573972 -12.408175 +4233 1002 6 0 27.293890 -3.784569 13.095470 +4234 1002 4 0 27.629930 -4.552840 12.571336 +4235 1002 4 0 27.297508 -4.139921 14.014667 +4236 1003 6 0 26.677289 -8.930589 -5.080635 +4237 1003 4 0 27.349144 -8.367067 -5.399678 +4238 1003 4 0 26.178389 -8.423219 -4.437089 +4239 1004 6 0 26.303353 -13.709693 -10.199064 +4240 1004 4 0 26.819339 -13.575870 -11.047002 +4241 1004 4 0 26.995460 -13.448744 -9.504732 +4242 1005 6 0 -5.782538 -6.137070 -18.577558 +4243 1005 4 0 -5.225175 -5.601455 -18.004594 +4244 1005 4 0 -5.277523 -6.828742 -18.969936 +4245 1006 6 0 -10.751593 15.373515 -8.362078 +4246 1006 4 0 -10.116580 15.133048 -9.031534 +4247 1006 4 0 -11.426882 15.817389 -8.872810 +4248 1007 6 0 16.641528 -6.647086 14.042481 +4249 1007 4 0 16.877857 -5.780320 14.352388 +4250 1007 4 0 15.723201 -6.556522 13.694961 +4251 1008 6 0 -9.692102 -20.433174 12.075319 +4252 1008 4 0 -9.015496 -20.798185 11.574612 +4253 1008 4 0 -10.349277 -21.179838 12.030713 +4254 1009 6 0 -3.342987 5.338933 20.099174 +4255 1009 4 0 -3.147711 5.827567 20.954747 +4256 1009 4 0 -4.124775 5.753362 19.736033 +4257 1010 6 0 22.616008 -14.603236 0.953729 +4258 1010 4 0 21.991188 -13.989371 1.394272 +4259 1010 4 0 22.974372 -14.081510 0.229956 +4260 1011 6 0 -8.097592 12.140479 -19.585886 +4261 1011 4 0 -8.453866 12.623380 -20.326053 +4262 1011 4 0 -8.784224 11.654989 -19.152969 +4263 1012 6 0 -21.232297 5.610953 -16.679404 +4264 1012 4 0 -20.585466 5.060918 -17.156512 +4265 1012 4 0 -21.930038 5.836903 -17.294471 +4266 1013 6 0 -10.747633 18.133699 -14.681278 +4267 1013 4 0 -10.847151 18.670752 -15.499579 +4268 1013 4 0 -9.785896 18.213162 -14.415037 +4269 1014 6 0 5.277447 -4.914937 -12.832056 +4270 1014 4 0 4.837973 -4.063025 -13.209955 +4271 1014 4 0 6.186619 -4.697637 -12.711347 +4272 1015 6 0 20.041500 5.021710 -2.968457 +4273 1015 4 0 19.672986 5.469423 -2.234503 +4274 1015 4 0 20.344328 4.132583 -2.637240 +4275 1016 6 0 17.907741 2.778212 -8.037993 +4276 1016 4 0 18.567517 3.366180 -8.410651 +4277 1016 4 0 17.288995 3.302520 -7.441301 +4278 1017 6 0 5.562515 -18.543574 -19.590057 +4279 1017 4 0 6.312662 -18.495893 -20.210476 +4280 1017 4 0 5.830551 -17.824826 -18.960179 +4281 1018 6 0 12.736551 -13.896404 -1.831403 +4282 1018 4 0 12.773597 -12.929037 -1.656141 +4283 1018 4 0 13.175198 -14.041740 -2.708482 +4284 1019 6 0 -4.469179 -3.097942 -13.481704 +4285 1019 4 0 -3.873920 -2.479353 -13.901987 +4286 1019 4 0 -5.276658 -2.695674 -13.122340 +4287 1020 6 0 -21.439043 8.219030 17.863426 +4288 1020 4 0 -21.056703 8.853759 17.338517 +4289 1020 4 0 -21.129569 7.386574 17.512818 +4290 1021 6 0 -20.342022 -7.199464 17.782819 +4291 1021 4 0 -19.811208 -6.577246 18.288787 +4292 1021 4 0 -19.701668 -7.908647 17.571092 +4293 1022 6 0 -14.263922 5.278640 -18.510906 +4294 1022 4 0 -13.564113 4.937165 -17.913388 +4295 1022 4 0 -14.930181 4.580837 -18.615930 +4296 1023 6 0 16.913731 -14.141037 14.480884 +4297 1023 4 0 16.066655 -13.798463 14.461234 +4298 1023 4 0 17.548578 -13.399940 14.431310 +4299 1024 6 0 -25.968088 14.659464 5.007859 +4300 1024 4 0 -25.454004 13.822928 4.891375 +4301 1024 4 0 -26.104124 14.757551 5.974942 +4302 1025 6 0 -18.135969 17.732537 5.080161 +4303 1025 4 0 -18.773193 18.355342 5.390012 +4304 1025 4 0 -18.159466 17.860761 4.093910 +4305 1026 6 0 -27.275820 -16.400609 -7.043757 +4306 1026 4 0 -26.590275 -16.756481 -6.431378 +4307 1026 4 0 -27.617212 -15.617979 -6.640114 +4308 1027 6 0 24.748058 17.280534 18.064239 +4309 1027 4 0 25.308718 17.915370 18.504903 +4310 1027 4 0 24.056361 17.050512 18.710421 +4311 1028 6 0 -24.811053 1.584408 5.834113 +4312 1028 4 0 -25.507909 1.858017 6.420755 +4313 1028 4 0 -25.030959 2.043401 4.912778 +4314 1029 6 0 -17.538048 -16.019040 8.437894 +4315 1029 4 0 -16.656025 -15.917276 8.786670 +4316 1029 4 0 -18.001949 -16.630915 9.146335 +4317 1030 6 0 24.760362 7.007344 2.270076 +4318 1030 4 0 25.402754 6.314627 2.489308 +4319 1030 4 0 23.915754 6.586671 2.268737 +4320 1031 6 0 25.788659 -3.059441 10.761911 +4321 1031 4 0 26.310282 -3.490606 11.381049 +4322 1031 4 0 26.152501 -2.184136 10.493232 +4323 1032 6 0 0.555207 13.578019 -13.771204 +4324 1032 4 0 0.341766 12.780750 -14.192088 +4325 1032 4 0 0.413626 13.443525 -12.823611 +4326 1033 6 0 20.410457 17.119094 12.037026 +4327 1033 4 0 20.229518 17.254716 12.960534 +4328 1033 4 0 19.888401 16.300517 11.792550 +4329 1034 6 0 -23.997550 7.377972 16.665323 +4330 1034 4 0 -23.725736 7.038438 15.778438 +4331 1034 4 0 -23.233133 7.945952 17.026136 +4332 1035 6 0 10.209255 5.785175 12.171401 +4333 1035 4 0 10.101397 6.356166 11.459081 +4334 1035 4 0 9.657068 5.061974 12.024038 +4335 1036 6 0 18.434676 -10.560721 -17.755033 +4336 1036 4 0 18.443899 -11.522200 -17.622101 +4337 1036 4 0 18.319805 -10.178413 -16.882655 +4338 1037 6 0 -27.095192 -12.657493 -12.643385 +4339 1037 4 0 -26.627310 -12.318558 -13.484881 +4340 1037 4 0 -26.470420 -12.949131 -11.963689 +4341 1038 6 0 -16.616222 15.445597 -12.118963 +4342 1038 4 0 -16.900898 14.503610 -11.855586 +4343 1038 4 0 -15.694269 15.632029 -11.755889 +4344 1039 6 0 21.704052 -7.110846 5.569340 +4345 1039 4 0 21.462097 -8.042671 5.894386 +4346 1039 4 0 20.943089 -6.635884 5.906995 +4347 1040 6 0 18.206432 16.827370 1.010928 +4348 1040 4 0 17.640465 17.264033 0.353478 +4349 1040 4 0 17.852918 17.062780 1.898646 +4350 1041 6 0 -11.473367 18.497190 -2.566431 +4351 1041 4 0 -11.979906 19.196582 -2.198797 +4352 1041 4 0 -11.280546 18.932999 -3.450291 +4353 1042 6 0 17.797648 10.068787 -6.366632 +4354 1042 4 0 17.894506 9.407090 -5.699458 +4355 1042 4 0 18.545928 9.973231 -6.994936 +4356 1043 6 0 -18.401148 -11.350055 -12.827243 +4357 1043 4 0 -18.476782 -10.412318 -13.195678 +4358 1043 4 0 -17.491834 -11.585994 -12.934422 +4359 1044 6 0 -16.495719 -5.941792 10.422239 +4360 1044 4 0 -16.334766 -5.213442 11.122849 +4361 1044 4 0 -16.639135 -6.780551 10.923477 +4362 1045 6 0 -11.586396 18.803652 -7.549338 +4363 1045 4 0 -12.019098 18.189302 -8.166804 +4364 1045 4 0 -11.712347 18.317066 -6.668883 +4365 1046 6 0 11.058497 -1.697211 6.108850 +4366 1046 4 0 11.596453 -0.983751 6.451941 +4367 1046 4 0 10.144328 -1.357434 6.135852 +4368 1047 6 0 -6.655801 13.749288 -17.439254 +4369 1047 4 0 -7.132448 13.358752 -18.156046 +4370 1047 4 0 -7.118927 14.596314 -17.196637 +4371 1048 6 0 1.472049 -16.138831 -18.127087 +4372 1048 4 0 0.854396 -15.448228 -18.418147 +4373 1048 4 0 2.130556 -15.578106 -17.697816 +4374 1049 6 0 20.585602 0.045789 -20.805188 +4375 1049 4 0 19.811710 0.249922 -20.316920 +4376 1049 4 0 20.451948 -0.908979 -20.865716 +4377 1050 6 0 -17.322452 12.895993 -11.204513 +4378 1050 4 0 -17.802771 12.549260 -12.003007 +4379 1050 4 0 -17.950866 13.176295 -10.574188 +4380 1051 6 0 -5.523481 17.380120 9.246553 +4381 1051 4 0 -6.455503 17.665024 9.326329 +4382 1051 4 0 -5.168113 17.988295 8.544540 +4383 1052 6 0 -20.625677 5.350199 17.142096 +4384 1052 4 0 -20.365541 5.269750 16.185658 +4385 1052 4 0 -21.560214 5.201087 17.226176 +4386 1053 6 0 14.783181 -14.244465 0.085624 +4387 1053 4 0 14.103412 -14.020780 -0.585079 +4388 1053 4 0 15.175676 -13.378076 0.287496 +4389 1054 6 0 -6.126500 15.521051 20.750377 +4390 1054 4 0 -5.864785 16.375379 20.437098 +4391 1054 4 0 -5.831488 14.924080 20.076176 +4392 1055 6 0 23.807408 -1.524862 20.387679 +4393 1055 4 0 23.526614 -0.919002 21.138248 +4394 1055 4 0 24.692883 -1.828224 20.645004 +4395 1056 6 0 -19.809983 -10.410676 13.714221 +4396 1056 4 0 -20.768119 -10.598102 13.488906 +4397 1056 4 0 -19.553271 -11.125518 14.242975 +4398 1057 6 0 10.977545 9.011145 -2.389433 +4399 1057 4 0 10.555694 9.915559 -2.389522 +4400 1057 4 0 11.154202 8.870964 -1.470695 +4401 1058 6 0 -1.783860 4.881032 16.604931 +4402 1058 4 0 -1.311789 5.388703 17.223932 +4403 1058 4 0 -2.422445 4.514982 17.225489 +4404 1059 6 0 7.835617 -8.106110 -15.760424 +4405 1059 4 0 7.624633 -7.756681 -14.894547 +4406 1059 4 0 8.420342 -7.335138 -16.124751 +4407 1060 6 0 -23.662148 -13.962817 6.282978 +4408 1060 4 0 -23.067991 -14.398941 6.936570 +4409 1060 4 0 -23.877149 -14.577723 5.532763 +4410 1061 6 0 -23.624539 2.173832 -0.854956 +4411 1061 4 0 -23.179146 2.179020 0.040340 +4412 1061 4 0 -23.749597 1.237465 -1.001396 +4413 1062 6 0 -21.224847 4.257385 -6.009865 +4414 1062 4 0 -20.741474 3.800756 -5.299605 +4415 1062 4 0 -22.182298 4.137922 -5.723698 +4416 1063 6 0 -7.017487 16.063624 -12.051636 +4417 1063 4 0 -6.269158 16.416276 -11.536793 +4418 1063 4 0 -7.636713 15.594733 -11.454123 +4419 1064 6 0 -5.651528 10.093505 -13.321462 +4420 1064 4 0 -6.401351 10.663800 -13.086078 +4421 1064 4 0 -5.597617 10.115851 -14.301208 +4422 1065 6 0 21.418715 -14.140702 -12.149975 +4423 1065 4 0 21.861018 -14.674641 -11.447553 +4424 1065 4 0 21.182805 -13.281849 -11.830093 +4425 1066 6 0 11.675702 -2.428019 -16.058290 +4426 1066 4 0 12.296485 -3.131417 -15.821102 +4427 1066 4 0 10.819347 -2.825354 -16.198440 +4428 1067 6 0 22.979820 -2.598953 7.858168 +4429 1067 4 0 22.305897 -3.288078 7.958439 +4430 1067 4 0 22.577225 -1.844154 8.317572 +4431 1068 6 0 -12.448543 -5.982245 -10.570856 +4432 1068 4 0 -12.345287 -6.440367 -11.438582 +4433 1068 4 0 -12.479780 -5.112730 -10.871625 +4434 1069 6 0 -21.326982 14.741209 3.984994 +4435 1069 4 0 -22.133596 15.218464 4.095957 +4436 1069 4 0 -21.095649 14.791647 3.001164 +4437 1070 6 0 -18.292976 8.601702 17.515296 +4438 1070 4 0 -17.819784 7.959109 16.915944 +4439 1070 4 0 -18.716579 9.254092 16.954312 +4440 1071 6 0 20.829524 -9.495435 17.330944 +4441 1071 4 0 20.166412 -8.937403 16.904816 +4442 1071 4 0 20.227087 -10.108486 17.846508 +4443 1072 6 0 20.700328 -6.588173 14.108279 +4444 1072 4 0 21.318200 -6.371434 13.409947 +4445 1072 4 0 20.919049 -5.966297 14.775431 +4446 1073 6 0 20.232319 2.519356 -1.744863 +4447 1073 4 0 19.792632 2.343537 -0.866566 +4448 1073 4 0 20.751642 1.718603 -1.892919 +4449 1074 6 0 15.047686 14.467227 0.247890 +4450 1074 4 0 15.482736 13.695414 -0.222271 +4451 1074 4 0 15.218594 15.203623 -0.400616 +4452 1075 6 0 24.814901 -4.572712 18.521288 +4453 1075 4 0 24.436069 -3.989712 17.861088 +4454 1075 4 0 24.560432 -4.263207 19.423396 +4455 1076 6 0 3.169892 -14.115589 5.242292 +4456 1076 4 0 2.664005 -13.989979 6.094893 +4457 1076 4 0 4.025199 -14.428367 5.639157 +4458 1077 6 0 -17.864265 -2.850216 -5.852738 +4459 1077 4 0 -17.430066 -2.321482 -5.131734 +4460 1077 4 0 -17.446095 -3.672125 -5.727214 +4461 1078 6 0 -13.642312 16.367207 3.840240 +4462 1078 4 0 -13.546920 17.318166 3.892058 +4463 1078 4 0 -12.985388 16.154870 4.544614 +4464 1079 6 0 15.575472 3.168399 -6.551464 +4465 1079 4 0 15.114514 3.591709 -7.323565 +4466 1079 4 0 15.203187 3.608807 -5.831817 +4467 1080 6 0 -21.816911 -17.666243 7.967285 +4468 1080 4 0 -21.649191 -17.232658 7.144499 +4469 1080 4 0 -22.407552 -17.039323 8.334081 +4470 1081 6 0 -19.125021 -12.172620 15.597940 +4471 1081 4 0 -18.215275 -12.242849 15.770287 +4472 1081 4 0 -19.633754 -12.872939 15.973922 +4473 1082 6 0 17.584300 -5.074564 -0.037211 +4474 1082 4 0 18.183319 -5.137038 0.675699 +4475 1082 4 0 18.235909 -5.047683 -0.784982 +4476 1083 6 0 26.562235 4.146721 -10.779327 +4477 1083 4 0 27.258204 4.596271 -10.364313 +4478 1083 4 0 26.892796 3.237656 -11.037254 +4479 1084 6 0 -23.034850 1.331983 -7.473112 +4480 1084 4 0 -22.263084 1.153047 -6.915575 +4481 1084 4 0 -23.725786 1.086847 -6.826224 +4482 1085 6 0 24.491038 14.753421 2.384575 +4483 1085 4 0 24.275342 13.963741 2.927789 +4484 1085 4 0 25.462558 14.841355 2.559853 +4485 1086 6 0 25.756605 20.905461 -14.371089 +4486 1086 4 0 25.459034 20.605712 -13.483891 +4487 1086 4 0 25.637109 21.868510 -14.335232 +4488 1087 6 0 18.144532 -1.757335 -11.270502 +4489 1087 4 0 18.514080 -2.646244 -11.055555 +4490 1087 4 0 18.939318 -1.202686 -11.251734 +4491 1088 6 0 -8.201074 -18.018606 -17.312094 +4492 1088 4 0 -8.700168 -17.307968 -17.835946 +4493 1088 4 0 -7.577873 -18.381345 -17.962687 +4494 1089 6 0 -9.369914 -19.217851 -15.403305 +4495 1089 4 0 -8.952768 -18.975805 -16.243189 +4496 1089 4 0 -8.911643 -18.742350 -14.709664 +4497 1090 6 0 20.100577 4.488027 -15.212556 +4498 1090 4 0 20.248911 5.438169 -15.424742 +4499 1090 4 0 20.660237 3.933680 -15.689536 +4500 1091 6 0 -19.712024 -15.323556 12.551955 +4501 1091 4 0 -19.317175 -16.207750 12.463402 +4502 1091 4 0 -19.212616 -14.787825 13.210358 +4503 1092 6 0 3.258787 -7.943131 12.290678 +4504 1092 4 0 2.342628 -8.287555 12.320149 +4505 1092 4 0 3.267355 -6.993463 12.332634 +4506 1093 6 0 -18.302710 1.278985 -16.334436 +4507 1093 4 0 -17.378406 1.373256 -16.132103 +4508 1093 4 0 -18.777760 1.517880 -15.493665 +4509 1094 6 0 16.870546 4.656852 -17.868704 +4510 1094 4 0 15.857496 4.704340 -17.988259 +4511 1094 4 0 17.247038 4.338791 -18.723974 +4512 1095 6 0 -15.333473 15.071500 7.805725 +4513 1095 4 0 -15.704647 14.257623 8.137122 +4514 1095 4 0 -15.627172 15.251727 6.915271 +4515 1096 6 0 9.979483 20.165851 2.918770 +4516 1096 4 0 9.638769 20.645174 2.150266 +4517 1096 4 0 9.859690 19.210620 2.805973 +4518 1097 6 0 23.413497 4.631399 15.271695 +4519 1097 4 0 23.659592 4.570914 14.363590 +4520 1097 4 0 23.076746 5.481003 15.471203 +4521 1098 6 0 23.514270 -0.269090 17.919270 +4522 1098 4 0 23.883706 -0.646818 18.744448 +4523 1098 4 0 22.647737 0.129763 18.103196 +4524 1099 6 0 -24.064290 4.819702 1.332253 +4525 1099 4 0 -24.383325 4.040819 1.008702 +4526 1099 4 0 -23.189236 4.997095 0.898826 +4527 1100 6 0 -25.779315 -8.150537 18.610217 +4528 1100 4 0 -24.782772 -7.888401 18.544405 +4529 1100 4 0 -26.257671 -7.381934 18.370006 +4530 1101 6 0 23.115913 16.716123 3.668102 +4531 1101 4 0 23.749362 16.385349 2.997452 +4532 1101 4 0 23.088241 17.666029 3.599261 +4533 1102 6 0 -20.088868 -15.143633 -10.159937 +4534 1102 4 0 -19.953025 -14.270168 -10.582681 +4535 1102 4 0 -19.990998 -15.687042 -10.954781 +4536 1103 6 0 7.102126 -1.136927 20.971306 +4537 1103 4 0 6.576190 -1.521838 20.280208 +4538 1103 4 0 7.955207 -1.040834 20.509983 +4539 1104 6 0 -2.534299 9.690544 11.933304 +4540 1104 4 0 -2.860248 8.888179 11.453477 +4541 1104 4 0 -1.828854 10.072496 11.393589 +4542 1105 6 0 12.023524 -9.150206 -14.165841 +4543 1105 4 0 11.362618 -9.759930 -14.520833 +4544 1105 4 0 12.740525 -9.263946 -14.788240 +4545 1106 6 0 15.791803 18.545995 0.850378 +4546 1106 4 0 16.437977 18.981342 1.416680 +4547 1106 4 0 14.975349 18.624193 1.311898 +4548 1107 6 0 -23.993331 13.937802 7.429388 +4549 1107 4 0 -23.946766 13.591295 6.487146 +4550 1107 4 0 -23.318125 14.639075 7.439315 +4551 1108 6 0 23.938328 -2.346007 3.554880 +4552 1108 4 0 24.343685 -3.093714 4.072487 +4553 1108 4 0 24.649326 -2.174810 2.889988 +4554 1109 6 0 -1.744771 13.957566 2.002292 +4555 1109 4 0 -0.940707 14.398422 2.247093 +4556 1109 4 0 -2.025476 14.420450 1.204293 +4557 1110 6 0 -25.534328 -15.482539 7.809635 +4558 1110 4 0 -25.054678 -15.173162 7.005447 +4559 1110 4 0 -26.465036 -15.629268 7.587481 +4560 1111 6 0 24.624742 -18.307755 -10.821110 +4561 1111 4 0 23.724217 -18.723401 -10.975653 +4562 1111 4 0 24.780187 -17.602754 -11.546790 +4563 1112 6 0 -21.325143 19.316329 -1.400937 +4564 1112 4 0 -21.154588 18.656956 -0.705637 +4565 1112 4 0 -20.679486 19.156150 -2.095481 +4566 1113 6 0 0.559384 -5.922570 14.213390 +4567 1113 4 0 1.239405 -5.963730 14.899585 +4568 1113 4 0 0.030681 -5.131536 14.297850 +4569 1114 6 0 7.056613 12.758986 15.777863 +4570 1114 4 0 6.345829 12.596606 16.456405 +4571 1114 4 0 6.917568 12.084839 15.095389 +4572 1115 6 0 7.882824 3.878180 -19.492657 +4573 1115 4 0 7.490185 4.569137 -19.983338 +4574 1115 4 0 7.617907 3.037912 -19.945297 +4575 1116 6 0 -4.242915 -9.821169 16.240099 +4576 1116 4 0 -5.114830 -10.078772 16.528494 +4577 1116 4 0 -4.353835 -8.852979 15.979121 +4578 1117 6 0 15.302976 18.208896 -11.851032 +4579 1117 4 0 14.901111 18.506138 -12.642478 +4580 1117 4 0 14.917266 17.320837 -11.712610 +4581 1118 6 0 -18.266869 -16.450266 -8.528802 +4582 1118 4 0 -19.072723 -16.071961 -9.086324 +4583 1118 4 0 -18.243043 -17.366820 -8.807270 +4584 1119 6 0 16.535819 -20.059315 20.261479 +4585 1119 4 0 16.531825 -20.982895 19.988148 +4586 1119 4 0 16.217098 -19.563433 19.483491 +4587 1120 6 0 -10.711611 3.116140 -11.835025 +4588 1120 4 0 -10.699224 2.230856 -12.204415 +4589 1120 4 0 -10.469479 3.689824 -12.532473 +4590 1121 6 0 -3.907796 14.129489 -14.135830 +4591 1121 4 0 -3.774958 15.065764 -14.110303 +4592 1121 4 0 -4.871885 13.969469 -14.280187 +4593 1122 6 0 -0.848559 15.883551 -14.784892 +4594 1122 4 0 -0.414200 14.990499 -14.630689 +4595 1122 4 0 -1.164070 15.745918 -15.703167 +4596 1123 6 0 26.710694 15.162885 -7.381020 +4597 1123 4 0 26.708875 16.144027 -7.444500 +4598 1123 4 0 27.516272 14.997257 -7.900997 +4599 1124 6 0 -20.320110 2.222669 -14.437513 +4600 1124 4 0 -20.674693 1.937159 -13.587288 +4601 1124 4 0 -21.090888 2.252982 -14.954492 +4602 1125 6 0 -18.681714 17.640935 -1.514728 +4603 1125 4 0 -19.273979 17.179134 -2.084688 +4604 1125 4 0 -18.333083 16.926527 -0.959606 +4605 1126 6 0 26.297214 0.194896 -8.814341 +4606 1126 4 0 26.092612 0.771392 -8.062520 +4607 1126 4 0 25.469129 -0.223458 -9.080468 +4608 1127 6 0 5.191134 -6.332696 -10.274288 +4609 1127 4 0 6.147598 -6.194127 -10.166488 +4610 1127 4 0 4.968608 -5.815003 -11.012193 +4611 1128 6 0 20.219068 -19.874563 -6.779564 +4612 1128 4 0 19.984433 -20.709740 -7.181101 +4613 1128 4 0 20.478152 -20.150413 -5.862690 +4614 1129 6 0 15.925069 -5.315100 -4.962971 +4615 1129 4 0 16.483651 -4.538813 -4.855095 +4616 1129 4 0 16.031011 -5.844220 -4.094051 +4617 1130 6 0 -24.041642 -19.508457 3.561309 +4618 1130 4 0 -23.889244 -19.214184 4.445568 +4619 1130 4 0 -23.734917 -20.488280 3.584072 +4620 1131 6 0 -7.947126 8.409362 14.208637 +4621 1131 4 0 -8.729737 8.295090 13.605991 +4622 1131 4 0 -7.220157 7.896970 13.768244 +4623 1132 6 0 -20.888915 18.615896 3.147997 +4624 1132 4 0 -20.353651 18.339741 3.899224 +4625 1132 4 0 -20.608848 18.126465 2.400982 +4626 1133 6 0 26.799597 -16.513942 12.340813 +4627 1133 4 0 27.311676 -15.749176 12.455669 +4628 1133 4 0 26.641412 -16.884054 13.252799 +4629 1134 6 0 22.610810 -16.125525 -11.025534 +4630 1134 4 0 23.428805 -16.214604 -10.496780 +4631 1134 4 0 22.231404 -17.004775 -11.137826 +4632 1135 6 0 23.631086 9.762764 -6.151528 +4633 1135 4 0 22.831437 10.283165 -6.251895 +4634 1135 4 0 23.313903 8.866850 -6.410178 +4635 1136 6 0 10.407629 -5.135788 9.642425 +4636 1136 4 0 9.500671 -5.522467 9.593528 +4637 1136 4 0 10.722620 -5.079856 8.742604 +4638 1137 6 0 4.000382 -9.483456 -16.043131 +4639 1137 4 0 4.388443 -8.972484 -16.767773 +4640 1137 4 0 3.270597 -9.958423 -16.410357 +4641 1138 6 0 -25.904986 -15.880364 18.652683 +4642 1138 4 0 -26.778482 -15.886913 19.026359 +4643 1138 4 0 -25.526797 -16.780938 18.932335 +4644 1139 6 0 15.308933 1.325497 -13.930838 +4645 1139 4 0 15.049598 0.974163 -14.793125 +4646 1139 4 0 14.735466 2.123881 -13.829588 +4647 1140 6 0 -6.379415 2.888159 -18.944523 +4648 1140 4 0 -6.573457 2.028181 -19.291846 +4649 1140 4 0 -5.489918 2.985716 -19.266815 +4650 1141 6 0 -1.982477 0.360990 19.729630 +4651 1141 4 0 -2.393479 -0.007753 20.516214 +4652 1141 4 0 -2.616886 0.223553 19.013623 +4653 1142 6 0 1.410741 17.503605 17.946189 +4654 1142 4 0 1.299933 17.358511 17.001928 +4655 1142 4 0 1.382712 16.600387 18.282286 +4656 1143 6 0 -17.081613 19.032309 -4.304375 +4657 1143 4 0 -18.004189 18.728506 -4.171643 +4658 1143 4 0 -16.569290 18.434220 -3.790534 +4659 1144 6 0 26.981274 -11.552908 -3.820441 +4660 1144 4 0 26.121174 -11.624996 -4.253473 +4661 1144 4 0 27.276376 -10.703146 -4.209015 +4662 1145 6 0 20.095481 18.572235 3.036961 +4663 1145 4 0 20.026299 17.806007 3.594224 +4664 1145 4 0 20.832186 19.036343 3.467658 +4665 1146 6 0 -19.905861 6.946943 4.083849 +4666 1146 4 0 -19.307403 7.160688 3.357801 +4667 1146 4 0 -20.728729 7.427643 3.991449 +4668 1147 6 0 22.217595 -4.822160 -10.650121 +4669 1147 4 0 22.159340 -5.054178 -11.530210 +4670 1147 4 0 21.255204 -4.714847 -10.351112 +4671 1148 6 0 12.390352 -19.538948 -0.083493 +4672 1148 4 0 13.062326 -18.900361 -0.469572 +4673 1148 4 0 11.739170 -19.679826 -0.768861 +4674 1149 6 0 -11.756735 -11.595474 -18.753407 +4675 1149 4 0 -10.845705 -11.914606 -18.999006 +4676 1149 4 0 -11.631200 -10.619419 -18.528946 +4677 1150 6 0 16.531650 8.079043 16.659190 +4678 1150 4 0 16.426030 8.463579 15.788072 +4679 1150 4 0 17.442132 8.278108 16.859520 +4680 1151 6 0 10.052731 8.649788 -10.126307 +4681 1151 4 0 10.131192 7.907466 -9.580859 +4682 1151 4 0 10.118299 9.470033 -9.652222 +4683 1152 6 0 10.138877 6.520965 -16.282122 +4684 1152 4 0 9.429867 6.198945 -15.746097 +4685 1152 4 0 9.762597 7.172991 -16.879414 +4686 1153 6 0 -5.128627 7.237138 -16.384778 +4687 1153 4 0 -4.943315 6.311211 -16.467826 +4688 1153 4 0 -4.299328 7.630954 -16.159960 +4689 1154 6 0 18.467732 -4.333427 -7.973507 +4690 1154 4 0 17.685481 -3.749427 -7.814406 +4691 1154 4 0 18.051764 -5.199527 -7.872728 +4692 1155 6 0 -22.790877 -7.110126 -2.658913 +4693 1155 4 0 -22.592444 -7.612682 -1.822969 +4694 1155 4 0 -23.671839 -6.831554 -2.552705 +4695 1156 6 0 -5.452870 -18.001674 4.454273 +4696 1156 4 0 -5.227357 -18.684872 5.061214 +4697 1156 4 0 -6.200455 -17.594596 4.818204 +4698 1157 6 0 6.056152 -17.434479 -7.972778 +4699 1157 4 0 6.787809 -18.060671 -8.028928 +4700 1157 4 0 5.440331 -17.702859 -7.267591 +4701 1158 6 0 1.714168 -18.930287 -17.718130 +4702 1158 4 0 1.740272 -18.003727 -18.035560 +4703 1158 4 0 0.785802 -19.119877 -17.580120 +4704 1159 6 0 12.454449 16.569541 -9.572034 +4705 1159 4 0 13.143421 15.995002 -9.358789 +4706 1159 4 0 11.970081 16.409711 -8.733167 +4707 1160 6 0 21.377566 -4.531623 -13.959167 +4708 1160 4 0 21.220313 -4.586863 -14.883806 +4709 1160 4 0 20.718007 -3.864167 -13.706228 +4710 1161 6 0 27.229945 -1.071212 -13.106863 +4711 1161 4 0 26.536738 -0.401088 -12.953451 +4712 1161 4 0 27.406489 -1.591477 -12.306455 +4713 1162 6 0 0.993205 -20.183906 13.537173 +4714 1162 4 0 1.864290 -20.100713 13.823720 +4715 1162 4 0 0.417346 -20.489716 14.247240 +4716 1163 6 0 22.306745 2.581458 8.736617 +4717 1163 4 0 22.972169 3.057047 8.241655 +4718 1163 4 0 21.515448 2.587605 8.237638 +4719 1164 6 0 -24.994740 17.845616 8.243126 +4720 1164 4 0 -25.935974 17.671320 8.306538 +4721 1164 4 0 -24.615426 17.427508 9.019818 +4722 1165 6 0 3.628195 -4.198159 -16.200147 +4723 1165 4 0 4.404223 -4.757640 -16.114355 +4724 1165 4 0 2.941004 -4.862278 -16.461468 +4725 1166 6 0 26.808990 -14.261974 -5.551088 +4726 1166 4 0 26.801404 -13.726938 -6.334245 +4727 1166 4 0 25.872464 -14.345791 -5.184066 +4728 1167 6 0 13.355891 -16.600141 -3.794039 +4729 1167 4 0 13.295908 -17.531097 -3.472837 +4730 1167 4 0 14.114590 -16.215977 -3.304966 +4731 1168 6 0 -5.285172 -14.650134 6.726219 +4732 1168 4 0 -5.321392 -15.573092 6.451324 +4733 1168 4 0 -5.705533 -14.040342 6.049451 +4734 1169 6 0 -15.245133 11.577568 10.198692 +4735 1169 4 0 -14.684069 10.842805 9.868029 +4736 1169 4 0 -15.899308 11.783343 9.507232 +4737 1170 6 0 17.485666 -16.919340 -6.354127 +4738 1170 4 0 17.235852 -17.135664 -7.261939 +4739 1170 4 0 18.432637 -16.981881 -6.360484 +4740 1171 6 0 -9.901382 -6.924152 -10.070687 +4741 1171 4 0 -10.735776 -6.481799 -9.885298 +4742 1171 4 0 -10.186933 -7.424453 -10.836686 +4743 1172 6 0 -24.779066 9.890774 -10.589824 +4744 1172 4 0 -24.555747 10.752218 -10.986744 +4745 1172 4 0 -24.892417 10.088688 -9.640328 +4746 1173 6 0 -22.615173 9.224641 6.611089 +4747 1173 4 0 -22.778201 8.680839 5.764537 +4748 1173 4 0 -23.446696 9.423303 6.964274 +4749 1174 6 0 9.268447 -16.931793 -5.987149 +4750 1174 4 0 8.956403 -16.451784 -6.788388 +4751 1174 4 0 9.877183 -16.351625 -5.503938 +4752 1175 6 0 -14.656535 1.482956 18.890158 +4753 1175 4 0 -15.369331 1.942366 19.276786 +4754 1175 4 0 -14.153965 0.952532 19.494908 +4755 1176 6 0 5.277331 10.616617 -11.480664 +4756 1176 4 0 5.005306 11.447583 -11.898782 +4757 1176 4 0 5.358629 10.918462 -10.514309 +4758 1177 6 0 25.665486 11.699398 -16.256540 +4759 1177 4 0 25.839240 12.448046 -15.719245 +4760 1177 4 0 25.814575 10.942656 -15.634104 +4761 1178 6 0 21.920761 20.073624 -12.126972 +4762 1178 4 0 22.552772 19.967397 -11.382127 +4763 1178 4 0 21.479644 19.202351 -12.146674 +4764 1179 6 0 10.003073 19.989386 -7.403776 +4765 1179 4 0 9.439166 20.478736 -6.817011 +4766 1179 4 0 9.975278 19.064238 -7.087034 +4767 1180 6 0 24.639512 10.361086 12.201260 +4768 1180 4 0 24.706246 9.532944 12.698966 +4769 1180 4 0 25.008910 11.010832 12.873283 +4770 1181 6 0 -4.551351 -13.614062 11.550986 +4771 1181 4 0 -3.695594 -13.200426 11.181108 +4772 1181 4 0 -4.841622 -13.040560 12.238016 +4773 1182 6 0 13.925499 -14.277948 -16.852509 +4774 1182 4 0 13.468499 -13.949023 -16.059490 +4775 1182 4 0 13.404967 -13.901558 -17.624653 +4776 1183 6 0 -8.822453 18.672284 -1.497284 +4777 1183 4 0 -9.773739 18.628726 -1.762866 +4778 1183 4 0 -8.737384 19.554941 -1.117958 +4779 1184 6 0 -22.502543 14.174443 -14.775760 +4780 1184 4 0 -23.095969 13.602099 -14.242424 +4781 1184 4 0 -22.857075 15.080918 -14.689705 +4782 1185 6 0 14.064111 -5.559010 13.387762 +4783 1185 4 0 14.064485 -4.565565 13.355502 +4784 1185 4 0 13.283489 -5.675258 12.845674 +4785 1186 6 0 1.894767 -5.320136 -19.924307 +4786 1186 4 0 1.751326 -5.338831 -18.971201 +4787 1186 4 0 2.815685 -5.078504 -20.067932 +4788 1187 6 0 25.294324 -10.049317 -2.168254 +4789 1187 4 0 24.998964 -9.181655 -2.438448 +4790 1187 4 0 25.460965 -9.966915 -1.197557 +4791 1188 6 0 6.479700 -19.891353 1.298943 +4792 1188 4 0 5.533528 -20.103717 1.361966 +4793 1188 4 0 6.573201 -19.075339 0.809570 +4794 1189 6 0 -27.363431 -16.882485 4.699786 +4795 1189 4 0 -26.488335 -16.423824 4.667383 +4796 1189 4 0 -27.778495 -16.519493 5.529189 +4797 1190 6 0 21.647371 -10.967083 -0.688726 +4798 1190 4 0 21.307654 -11.566578 -0.059145 +4799 1190 4 0 20.903506 -10.948374 -1.343290 +4800 1191 6 0 -22.639740 18.869062 12.772784 +4801 1191 4 0 -23.598249 18.977251 12.816087 +4802 1191 4 0 -22.528147 18.565590 11.856412 +4803 1192 6 0 -19.354849 19.459324 -20.763860 +4804 1192 4 0 -19.638921 18.619981 -20.405119 +4805 1192 4 0 -19.999366 20.121418 -20.384538 +4806 1193 6 0 -27.292577 17.947849 -7.899480 +4807 1193 4 0 -26.865640 18.369463 -8.665053 +4808 1193 4 0 -26.976583 18.519563 -7.163255 +4809 1194 6 0 -20.817821 -2.868450 14.802525 +4810 1194 4 0 -21.140828 -3.572172 14.242551 +4811 1194 4 0 -21.382527 -2.899729 15.647552 +4812 1195 6 0 -26.483700 3.477220 -8.027358 +4813 1195 4 0 -27.118971 4.203207 -8.001463 +4814 1195 4 0 -25.572543 3.766211 -8.004075 +4815 1196 6 0 -20.066885 -9.761422 6.553470 +4816 1196 4 0 -20.997945 -9.935159 6.946701 +4817 1196 4 0 -19.442249 -9.796491 7.281455 +4818 1197 6 0 -23.097741 6.873436 -18.392975 +4819 1197 4 0 -22.589483 6.725087 -19.200274 +4820 1197 4 0 -22.785797 7.752769 -18.098029 +4821 1198 6 0 18.849536 1.746914 0.846251 +4822 1198 4 0 18.128002 2.129064 0.287715 +4823 1198 4 0 19.181226 2.420341 1.435040 +4824 1199 6 0 27.002887 18.923510 11.873786 +4825 1199 4 0 27.227664 19.764419 11.414163 +4826 1199 4 0 26.105946 19.033421 11.984937 +4827 1200 6 0 -11.158512 11.141322 18.442481 +4828 1200 4 0 -11.408050 10.995491 17.540347 +4829 1200 4 0 -10.502213 10.475024 18.734764 +4830 1201 6 0 -21.495790 -1.351514 -4.237645 +4831 1201 4 0 -21.044359 -1.664515 -3.433502 +4832 1201 4 0 -22.384314 -1.671646 -4.060127 +4833 1202 6 0 15.621755 -15.205139 -2.495677 +4834 1202 4 0 15.424484 -14.934581 -1.611471 +4835 1202 4 0 16.121625 -14.529114 -2.853796 +4836 1203 6 0 4.381992 13.875981 -1.032186 +4837 1203 4 0 5.333475 13.689707 -0.896179 +4838 1203 4 0 4.022732 13.223499 -1.665135 +4839 1204 6 0 20.177887 10.395959 -3.696541 +4840 1204 4 0 20.356404 10.914845 -4.496586 +4841 1204 4 0 20.991017 10.244340 -3.211612 +4842 1205 6 0 15.157815 19.249081 -18.039544 +4843 1205 4 0 15.352336 20.161425 -17.776001 +4844 1205 4 0 15.059841 19.346261 -19.002141 +4845 1206 6 0 -7.108984 -13.295157 15.804846 +4846 1206 4 0 -6.929809 -14.169985 15.496547 +4847 1206 4 0 -6.361874 -13.100921 16.402035 +4848 1207 6 0 -25.065030 -11.005040 18.970744 +4849 1207 4 0 -25.902113 -11.429253 18.763963 +4850 1207 4 0 -25.182957 -10.072508 18.787257 +4851 1208 6 0 11.932413 -6.103636 -13.397989 +4852 1208 4 0 12.570617 -5.775336 -12.776618 +4853 1208 4 0 12.223586 -6.926860 -13.765008 +4854 1209 6 0 -25.022964 -4.047632 -16.421532 +4855 1209 4 0 -24.729550 -4.908790 -16.087160 +4856 1209 4 0 -24.546933 -3.445338 -15.856315 +4857 1210 6 0 -2.351505 -13.799895 -9.640381 +4858 1210 4 0 -2.806266 -13.103621 -10.108151 +4859 1210 4 0 -1.432803 -13.498454 -9.473869 +4860 1211 6 0 -17.970640 -1.824370 11.981061 +4861 1211 4 0 -18.720197 -1.276483 12.154733 +4862 1211 4 0 -17.669382 -2.084512 12.859437 +4863 1212 6 0 16.682335 16.786230 -5.408443 +4864 1212 4 0 15.963934 17.446355 -5.166695 +4865 1212 4 0 16.709036 16.877417 -6.391919 +4866 1213 6 0 -26.984415 4.176614 -3.075863 +4867 1213 4 0 -26.123649 4.345106 -2.684692 +4868 1213 4 0 -26.853761 3.725314 -3.913099 +4869 1214 6 0 -26.077892 0.261300 17.719641 +4870 1214 4 0 -26.784019 0.913023 17.543217 +4871 1214 4 0 -26.472468 -0.574255 17.882963 +4872 1215 6 0 22.927522 20.111945 -15.638008 +4873 1215 4 0 23.596986 20.008343 -14.934189 +4874 1215 4 0 22.343012 20.821690 -15.365852 +4875 1216 6 0 -5.579568 -12.021256 13.421129 +4876 1216 4 0 -5.890589 -11.086014 13.250578 +4877 1216 4 0 -6.303487 -12.389144 13.952477 +4878 1217 6 0 2.458268 -17.079274 7.291369 +4879 1217 4 0 2.320253 -17.365496 8.234460 +4880 1217 4 0 1.770368 -16.394030 7.185697 +4881 1218 6 0 -24.595173 -15.448874 14.340370 +4882 1218 4 0 -23.877774 -15.587584 14.998240 +4883 1218 4 0 -25.176320 -14.635721 14.530870 +4884 1219 6 0 27.032054 -9.403183 3.148273 +4885 1219 4 0 26.403900 -8.794366 3.626157 +4886 1219 4 0 27.383095 -9.993711 3.825592 +4887 1220 6 0 -20.726606 14.795856 1.273133 +4888 1220 4 0 -19.806504 14.435167 1.199972 +4889 1220 4 0 -21.276966 14.325769 0.588346 +4890 1221 6 0 -24.967956 8.541628 1.328681 +4891 1221 4 0 -24.984827 9.452469 1.040896 +4892 1221 4 0 -25.740396 8.434977 1.929151 +4893 1222 6 0 -12.425328 11.518457 -14.199688 +4894 1222 4 0 -12.773966 12.392793 -14.015441 +4895 1222 4 0 -13.118630 10.965584 -13.849575 +4896 1223 6 0 -2.529035 -2.360811 17.836544 +4897 1223 4 0 -3.234696 -2.119216 18.386147 +4898 1223 4 0 -1.867440 -1.729883 18.015495 +4899 1224 6 0 -21.776402 4.919177 -10.291667 +4900 1224 4 0 -22.083924 5.863215 -10.349382 +4901 1224 4 0 -22.101633 4.482076 -11.074994 +4902 1225 6 0 6.293596 15.999990 18.747555 +4903 1225 4 0 5.792274 16.524552 19.421554 +4904 1225 4 0 5.641363 15.346197 18.513974 +4905 1226 6 0 8.520334 14.536496 -17.222476 +4906 1226 4 0 9.367910 14.362425 -16.812169 +4907 1226 4 0 8.183656 13.684606 -17.523424 +4908 1227 6 0 22.691056 10.129741 -9.774947 +4909 1227 4 0 22.388373 10.989892 -9.545078 +4910 1227 4 0 23.520258 10.122274 -10.228776 +4911 1228 6 0 11.292032 2.127043 14.679028 +4912 1228 4 0 10.300438 2.012949 14.574584 +4913 1228 4 0 11.707898 2.382716 13.839204 +4914 1229 6 0 -10.080449 15.590962 -5.638342 +4915 1229 4 0 -9.913581 15.482801 -6.607010 +4916 1229 4 0 -11.000029 15.446049 -5.572110 +4917 1230 6 0 9.724654 19.017882 -10.687275 +4918 1230 4 0 10.589720 19.426462 -10.594122 +4919 1230 4 0 9.112520 19.575919 -10.256988 +4920 1231 6 0 -3.018641 7.588470 16.688095 +4921 1231 4 0 -2.330160 6.909662 16.567035 +4922 1231 4 0 -3.336233 7.572799 15.739189 +4923 1232 6 0 -23.558310 -7.134740 -5.487980 +4924 1232 4 0 -23.265138 -7.142827 -4.583180 +4925 1232 4 0 -23.745933 -6.250685 -5.834602 +4926 1233 6 0 4.226629 15.093702 15.365734 +4927 1233 4 0 4.100578 14.882406 16.320809 +4928 1233 4 0 5.174530 15.177349 15.271261 +4929 1234 6 0 -7.236890 20.676688 -13.887599 +4930 1234 4 0 -7.297460 19.771023 -14.250227 +4931 1234 4 0 -6.598431 21.116314 -14.486914 +4932 1235 6 0 15.815010 1.151652 -17.502222 +4933 1235 4 0 15.282468 0.557615 -16.965425 +4934 1235 4 0 15.054480 1.630363 -17.957554 +4935 1236 6 0 -20.408893 -2.203285 -1.832435 +4936 1236 4 0 -20.785863 -1.600728 -1.206934 +4937 1236 4 0 -20.672903 -3.085785 -1.719471 +4938 1237 6 0 20.195914 -9.732203 -7.503586 +4939 1237 4 0 19.775594 -9.020266 -6.898678 +4940 1237 4 0 21.112065 -9.804356 -7.217365 +4941 1238 6 0 19.296629 -3.381575 11.843745 +4942 1238 4 0 19.274699 -4.314587 11.989050 +4943 1238 4 0 20.065392 -3.074363 12.391528 +4944 1239 6 0 6.531812 13.501627 -15.078637 +4945 1239 4 0 5.967341 14.060209 -15.705952 +4946 1239 4 0 6.508026 12.632112 -15.439267 +4947 1240 6 0 23.589867 -10.343367 -8.571682 +4948 1240 4 0 23.047931 -10.296334 -7.779151 +4949 1240 4 0 23.642788 -11.281031 -8.849406 +4950 1241 6 0 -13.933420 -9.985099 16.210161 +4951 1241 4 0 -13.061691 -9.875550 16.658981 +4952 1241 4 0 -13.656103 -10.632088 15.489463 +4953 1242 6 0 -23.237683 18.866731 19.359260 +4954 1242 4 0 -22.914140 19.726873 19.738290 +4955 1242 4 0 -23.718173 18.429834 20.073905 +4956 1243 6 0 10.494095 4.110524 19.341374 +4957 1243 4 0 9.723154 4.572616 18.942773 +4958 1243 4 0 11.209458 4.339646 18.681127 +4959 1244 6 0 1.369329 -9.441779 19.284078 +4960 1244 4 0 2.015289 -10.186860 19.212218 +4961 1244 4 0 1.015324 -9.189016 18.436693 +4962 1245 6 0 -12.121346 16.858305 -16.912154 +4963 1245 4 0 -12.482071 17.717178 -16.927558 +4964 1245 4 0 -11.557811 16.791147 -17.773819 +4965 1246 6 0 -9.672999 19.181029 4.107845 +4966 1246 4 0 -8.970953 19.839775 3.892751 +4967 1246 4 0 -10.347573 19.719934 4.574402 +4968 1247 6 0 -25.848254 19.893856 -6.158583 +4969 1247 4 0 -26.297371 20.306721 -5.458518 +4970 1247 4 0 -25.747309 20.595741 -6.795744 +4971 1248 6 0 -23.033567 -20.060181 19.659192 +4972 1248 4 0 -22.235177 -19.955724 19.067747 +4973 1248 4 0 -23.368334 -19.148619 19.847979 +4974 1249 6 0 -15.791938 8.271699 18.828418 +4975 1249 4 0 -16.027582 7.356294 18.646313 +4976 1249 4 0 -16.655172 8.767091 18.686291 +4977 1250 6 0 -21.708167 13.277512 -0.641646 +4978 1250 4 0 -22.597047 13.562637 -0.909355 +4979 1250 4 0 -21.809236 12.333829 -0.325507 +4980 1251 6 0 5.941295 -12.360207 -6.112984 +4981 1251 4 0 6.359630 -11.626042 -5.736075 +4982 1251 4 0 6.495648 -12.726477 -6.802834 +4983 1252 6 0 13.032092 -7.701355 -9.994956 +4984 1252 4 0 13.027162 -8.501577 -10.533994 +4985 1252 4 0 12.548921 -8.005933 -9.172971 +4986 1253 6 0 -21.030949 -20.119698 18.010996 +4987 1253 4 0 -20.244199 -20.716690 18.012037 +4988 1253 4 0 -20.696565 -19.252737 17.848450 +4989 1254 6 0 -19.015223 -0.571456 18.155941 +4990 1254 4 0 -19.180719 -0.389583 17.176932 +4991 1254 4 0 -18.385462 0.098617 18.394716 +4992 1255 6 0 -20.138485 -4.252628 -11.316573 +4993 1255 4 0 -19.840849 -5.049159 -11.793063 +4994 1255 4 0 -20.052902 -4.580000 -10.382886 +4995 1256 6 0 26.001968 -7.495414 4.672795 +4996 1256 4 0 25.441451 -7.324776 5.428706 +4997 1256 4 0 26.791498 -7.049997 4.959197 +4998 1257 6 0 19.055181 -8.349517 1.323580 +4999 1257 4 0 19.813936 -8.781204 1.703347 +5000 1257 4 0 19.440205 -7.777422 0.589952 +5001 1258 6 0 25.264798 8.233933 8.591555 +5002 1258 4 0 25.487528 8.137778 9.540405 +5003 1258 4 0 25.431397 9.162412 8.389274 +5004 1259 6 0 12.847916 19.693484 13.048286 +5005 1259 4 0 11.960267 19.995654 12.950099 +5006 1259 4 0 13.352276 20.516003 12.895948 +5007 1260 6 0 -1.639765 11.429914 5.808063 +5008 1260 4 0 -1.143950 12.047063 6.360614 +5009 1260 4 0 -2.350791 11.948090 5.492463 +5010 1261 6 0 9.848758 16.041115 -10.707370 +5011 1261 4 0 9.065082 15.706216 -11.123228 +5012 1261 4 0 9.845269 17.025290 -10.747608 +5013 1262 6 0 25.426954 20.293141 3.300623 +5014 1262 4 0 25.545358 20.769417 4.152492 +5015 1262 4 0 25.632270 21.033287 2.715396 +5016 1263 6 0 20.761109 8.207487 15.638898 +5017 1263 4 0 20.452100 8.556874 16.455577 +5018 1263 4 0 20.418491 7.276974 15.507884 +5019 1264 6 0 -17.340920 8.603213 9.973826 +5020 1264 4 0 -17.013776 7.715227 10.202262 +5021 1264 4 0 -17.708959 8.550775 9.106960 +5022 1265 6 0 -4.331343 4.519352 -17.647753 +5023 1265 4 0 -5.066787 3.870671 -17.637369 +5024 1265 4 0 -3.551869 3.998790 -17.434586 +5025 1266 6 0 20.173773 -17.092486 -7.001341 +5026 1266 4 0 19.888855 -16.443588 -7.714490 +5027 1266 4 0 20.413820 -17.900629 -7.443434 +5028 1267 6 0 -24.408814 -19.385733 11.225815 +5029 1267 4 0 -23.821161 -19.917061 10.749392 +5030 1267 4 0 -23.910074 -18.660169 11.617528 +5031 1268 6 0 17.324633 -1.128975 8.030022 +5032 1268 4 0 17.360905 -1.837044 8.692495 +5033 1268 4 0 18.151746 -0.980682 7.588726 +5034 1269 6 0 23.955106 -0.867756 -15.846487 +5035 1269 4 0 24.366679 -1.312193 -16.592677 +5036 1269 4 0 23.040207 -0.721605 -15.963924 +5037 1270 6 0 9.794322 -16.325238 -14.689703 +5038 1270 4 0 10.077445 -16.942203 -15.418778 +5039 1270 4 0 10.274190 -16.591924 -13.896103 +5040 1271 6 0 -19.734101 -12.095151 -17.153284 +5041 1271 4 0 -20.605684 -12.154989 -17.550952 +5042 1271 4 0 -19.490756 -11.177750 -17.393726 +5043 1272 6 0 2.145542 4.244476 10.559284 +5044 1272 4 0 1.712137 4.346774 11.448612 +5045 1272 4 0 1.552348 4.733416 9.969137 +5046 1273 6 0 -11.816250 3.934419 -18.405990 +5047 1273 4 0 -11.103191 4.038219 -19.027130 +5048 1273 4 0 -12.427642 3.303177 -18.846649 +5049 1274 6 0 18.893576 -19.279190 2.434753 +5050 1274 4 0 19.835933 -19.611541 2.415682 +5051 1274 4 0 18.743093 -19.115267 3.373179 +5052 1275 6 0 20.503855 18.939356 -0.359795 +5053 1275 4 0 20.047818 18.683781 0.506021 +5054 1275 4 0 19.907310 19.650581 -0.623461 +5055 1276 6 0 26.407017 7.546865 -12.797932 +5056 1276 4 0 25.672384 7.104790 -13.280274 +5057 1276 4 0 27.091777 7.777455 -13.451817 +5058 1277 6 0 25.647383 -6.341604 -8.154924 +5059 1277 4 0 26.357304 -5.715813 -8.365206 +5060 1277 4 0 25.997425 -7.137628 -8.663351 +5061 1278 6 0 24.828979 0.493040 8.418984 +5062 1278 4 0 25.575762 0.370102 9.128898 +5063 1278 4 0 24.779810 -0.342584 8.014099 +5064 1279 6 0 17.019067 17.317670 3.445072 +5065 1279 4 0 16.246945 17.951681 3.647617 +5066 1279 4 0 17.118513 16.924515 4.354268 +5067 1280 6 0 -14.811273 -9.813473 19.349487 +5068 1280 4 0 -15.258466 -10.583929 19.669257 +5069 1280 4 0 -14.033228 -10.041012 18.847205 +5070 1281 6 0 23.382015 -15.215511 6.306360 +5071 1281 4 0 24.055596 -14.464366 6.446483 +5072 1281 4 0 22.714188 -14.794741 5.753275 +5073 1282 6 0 -26.337628 -13.401476 1.412480 +5074 1282 4 0 -26.098445 -12.489264 1.304520 +5075 1282 4 0 -25.434229 -13.739613 1.185013 +5076 1283 6 0 12.045641 6.334478 14.034491 +5077 1283 4 0 11.290237 6.052909 13.448299 +5078 1283 4 0 12.782332 5.993917 13.490639 +5079 1284 6 0 20.125812 -8.202150 -9.814098 +5080 1284 4 0 20.194536 -8.887766 -9.162911 +5081 1284 4 0 21.027215 -8.057148 -10.044296 +5082 1285 6 0 12.066525 -8.540938 -7.364209 +5083 1285 4 0 11.508583 -8.030746 -6.799426 +5084 1285 4 0 11.560454 -9.411302 -7.497328 +5085 1286 6 0 6.006584 -19.643391 -16.856771 +5086 1286 4 0 5.834004 -19.490315 -17.723180 +5087 1286 4 0 5.173445 -19.306940 -16.418662 +5088 1287 6 0 -26.105240 9.497668 11.035009 +5089 1287 4 0 -25.940506 10.208588 11.676762 +5090 1287 4 0 -26.907023 9.839249 10.688906 +5091 1288 6 0 25.980779 -10.760099 -17.043079 +5092 1288 4 0 26.294152 -9.947887 -17.408944 +5093 1288 4 0 26.659719 -11.433214 -17.294305 +5094 1289 6 0 17.405056 -19.269747 -14.944723 +5095 1289 4 0 17.214410 -18.409556 -14.434720 +5096 1289 4 0 17.526094 -19.972476 -14.301658 +5097 1290 6 0 -24.018604 17.625199 1.640879 +5098 1290 4 0 -24.784080 17.611175 1.083900 +5099 1290 4 0 -24.038354 18.437262 2.233960 +5100 1291 6 0 -19.713596 9.725034 11.241378 +5101 1291 4 0 -20.334881 9.562447 10.458947 +5102 1291 4 0 -18.859792 9.431551 10.874150 +5103 1292 6 0 12.017227 10.801952 4.275634 +5104 1292 4 0 11.431320 10.637434 5.045035 +5105 1292 4 0 11.407446 10.560420 3.532631 +5106 1293 6 0 -2.032321 -18.778706 7.677870 +5107 1293 4 0 -1.174746 -18.822855 7.226095 +5108 1293 4 0 -2.302104 -17.849324 7.787431 +5109 1294 6 0 27.376193 5.800091 -18.808667 +5110 1294 4 0 28.217784 5.560939 -18.324424 +5111 1294 4 0 27.470430 6.797809 -18.833583 +5112 1295 6 0 22.777052 -4.203723 15.528690 +5113 1295 4 0 22.819825 -4.163457 14.596219 +5114 1295 4 0 23.290333 -4.967303 15.841471 +5115 1296 6 0 -24.407041 -11.771935 -2.162786 +5116 1296 4 0 -24.850114 -12.297116 -2.844402 +5117 1296 4 0 -24.335332 -10.842961 -2.448771 +5118 1297 6 0 26.515383 14.863308 -11.949090 +5119 1297 4 0 25.693505 15.247676 -11.698157 +5120 1297 4 0 27.137639 14.903509 -11.237657 +5121 1298 6 0 9.526170 19.544584 -4.495947 +5122 1298 4 0 8.563440 19.681938 -4.310177 +5123 1298 4 0 9.710873 20.389152 -4.948099 +5124 1299 6 0 0.930640 14.865621 2.693375 +5125 1299 4 0 1.441052 15.216977 2.015262 +5126 1299 4 0 0.982855 15.427541 3.521397 +5127 1300 6 0 -8.560884 -14.779791 -0.317309 +5128 1300 4 0 -7.563132 -14.724309 -0.578447 +5129 1300 4 0 -8.944725 -15.346794 -1.006948 +5130 1301 6 0 -7.319722 -18.863858 -20.528347 +5131 1301 4 0 -8.028502 -18.663258 -21.126375 +5132 1301 4 0 -7.164500 -19.772394 -20.500444 +5133 1302 6 0 -15.128995 -19.691380 3.092730 +5134 1302 4 0 -16.008789 -19.690772 3.472840 +5135 1302 4 0 -14.968322 -20.623238 2.789294 +5136 1303 6 0 14.985700 14.931491 -8.447163 +5137 1303 4 0 15.394555 15.826269 -8.282486 +5138 1303 4 0 14.583931 14.705829 -7.592039 +5139 1304 6 0 27.322481 11.495061 -9.977404 +5140 1304 4 0 26.863175 12.062729 -9.353442 +5141 1304 4 0 28.126888 11.829690 -10.258173 +5142 1305 6 0 -18.229397 7.978168 7.639376 +5143 1305 4 0 -19.028971 7.438874 7.807107 +5144 1305 4 0 -17.575997 7.370338 7.232298 +5145 1306 6 0 -5.554901 9.643950 18.209130 +5146 1306 4 0 -4.877908 10.197790 17.765078 +5147 1306 4 0 -5.709375 10.290933 18.919059 +5148 1307 6 0 27.055810 -8.039157 10.769461 +5149 1307 4 0 27.007722 -8.570107 10.005081 +5150 1307 4 0 26.186325 -7.596689 10.673325 +5151 1308 6 0 11.193144 -4.443017 6.826722 +5152 1308 4 0 10.836891 -3.569010 6.720665 +5153 1308 4 0 12.137206 -4.292318 6.939554 +5154 1309 6 0 19.268222 19.404109 -20.005983 +5155 1309 4 0 18.552307 19.427583 -20.612317 +5156 1309 4 0 20.054546 19.443947 -20.508778 +5157 1310 6 0 -0.489608 2.918279 -19.339493 +5158 1310 4 0 -0.728227 3.023881 -20.237208 +5159 1310 4 0 0.435524 3.253135 -19.140478 +5160 1311 6 0 -9.930055 10.868000 -17.673601 +5161 1311 4 0 -10.626469 11.466271 -17.943644 +5162 1311 4 0 -9.408670 11.199903 -16.908283 +5163 1312 6 0 14.391665 -7.492360 -17.133433 +5164 1312 4 0 14.776095 -6.640715 -16.914336 +5165 1312 4 0 14.844935 -7.826758 -17.919613 +5166 1313 6 0 -4.403090 17.562294 4.304967 +5167 1313 4 0 -3.639926 17.895809 4.788467 +5168 1313 4 0 -4.847822 18.247386 3.881416 +5169 1314 6 0 14.924216 -8.572989 -7.802421 +5170 1314 4 0 15.080791 -9.001730 -8.577899 +5171 1314 4 0 14.072292 -8.888256 -7.443501 +5172 1315 6 0 20.863060 -8.335281 -2.996473 +5173 1315 4 0 20.865038 -7.834818 -2.195694 +5174 1315 4 0 20.360014 -9.121641 -2.844384 +5175 1316 6 0 7.770701 4.749626 -15.173810 +5176 1316 4 0 7.232605 4.918984 -14.407401 +5177 1316 4 0 7.150893 4.735931 -15.889673 +5178 1317 6 0 9.287502 -20.421293 -19.615918 +5179 1317 4 0 8.673901 -19.918813 -20.140368 +5180 1317 4 0 10.257214 -20.289398 -19.904230 +5181 1318 6 0 20.543914 -3.694600 8.858562 +5182 1318 4 0 20.350529 -3.346561 9.790355 +5183 1318 4 0 20.284447 -4.620852 8.950478 +5184 1319 6 0 -24.889469 -2.826087 -11.161559 +5185 1319 4 0 -24.617642 -1.952238 -10.677372 +5186 1319 4 0 -25.879679 -2.907043 -11.066325 +5187 1320 6 0 16.046200 -19.874001 -17.403642 +5188 1320 4 0 16.633402 -19.935906 -18.189298 +5189 1320 4 0 16.556861 -19.594522 -16.612102 +5190 1321 6 0 5.741718 -12.703855 14.460309 +5191 1321 4 0 6.418646 -13.226075 14.848859 +5192 1321 4 0 5.375423 -12.291966 15.251474 +5193 1322 6 0 -26.921124 3.080708 -16.683288 +5194 1322 4 0 -26.349288 3.764354 -17.076383 +5195 1322 4 0 -27.310492 3.610598 -15.940909 +5196 1323 6 0 -9.051861 -12.598891 -10.481740 +5197 1323 4 0 -9.312975 -13.202994 -11.160740 +5198 1323 4 0 -9.863453 -12.002119 -10.435649 +5199 1324 6 0 11.222934 -19.072403 -5.120308 +5200 1324 4 0 10.662322 -18.478568 -5.660022 +5201 1324 4 0 12.014749 -19.325909 -5.638718 +5202 1325 6 0 18.944446 -1.761496 -1.989981 +5203 1325 4 0 19.143872 -2.715939 -1.959282 +5204 1325 4 0 18.884717 -1.422297 -1.082916 +5205 1326 6 0 23.550316 -15.829708 -20.623087 +5206 1326 4 0 22.847013 -15.261005 -20.962532 +5207 1326 4 0 23.291254 -16.269725 -19.776352 +5208 1327 6 0 16.851801 5.388343 15.856452 +5209 1327 4 0 16.397949 5.383405 15.017945 +5210 1327 4 0 16.364224 6.131529 16.215918 +5211 1328 6 0 12.029283 -15.298450 15.005226 +5212 1328 4 0 11.752968 -15.998705 15.556968 +5213 1328 4 0 11.367704 -14.915688 14.430927 +5214 1329 6 0 14.340396 -0.486882 2.372215 +5215 1329 4 0 13.663877 -0.866715 2.885453 +5216 1329 4 0 14.313669 0.446574 2.655905 +5217 1330 6 0 -4.590564 -6.037942 9.321481 +5218 1330 4 0 -4.191484 -6.200341 8.445394 +5219 1330 4 0 -4.057284 -5.373615 9.813704 +5220 1331 6 0 11.373242 -19.244304 -15.042581 +5221 1331 4 0 12.222601 -19.509329 -15.419988 +5222 1331 4 0 10.727440 -19.492586 -15.694712 +5223 1332 6 0 8.445009 -7.353337 -20.644303 +5224 1332 4 0 8.065671 -6.779925 -19.985343 +5225 1332 4 0 8.109658 -8.330016 -20.463794 +5226 1333 6 0 9.428901 8.662531 -17.428301 +5227 1333 4 0 8.456111 8.645724 -17.644511 +5228 1333 4 0 9.529146 9.218358 -16.645571 +5229 1334 6 0 -22.387040 -19.582592 -7.404304 +5230 1334 4 0 -22.537521 -18.739332 -7.873166 +5231 1334 4 0 -22.150442 -19.339940 -6.528223 +5232 1335 6 0 26.735971 -15.726321 7.121648 +5233 1335 4 0 25.953722 -16.106883 7.512069 +5234 1335 4 0 26.460359 -14.804570 6.934323 +5235 1336 6 0 -20.988572 11.929476 3.968066 +5236 1336 4 0 -21.340596 11.563124 4.784938 +5237 1336 4 0 -21.130650 12.884161 4.069043 +5238 1337 6 0 21.473005 20.923952 -4.710755 +5239 1337 4 0 22.324172 21.375208 -4.753044 +5240 1337 4 0 21.707980 20.020307 -4.884522 +5241 1338 6 0 18.479193 -0.888136 0.672743 +5242 1338 4 0 17.536329 -0.750808 0.451811 +5243 1338 4 0 18.753176 -0.016644 0.847545 +5244 1339 6 0 -13.644220 -0.195942 -16.728164 +5245 1339 4 0 -14.145608 -0.971886 -16.514909 +5246 1339 4 0 -13.412704 -0.294150 -17.655379 +5247 1340 6 0 -27.356282 -13.782004 3.934427 +5248 1340 4 0 -27.242980 -13.845896 2.900565 +5249 1340 4 0 -28.015991 -14.339318 4.193014 +5250 1341 6 0 18.276550 10.521821 -10.411508 +5251 1341 4 0 17.466149 10.037966 -10.334512 +5252 1341 4 0 18.135131 11.463023 -10.441937 +5253 1342 6 0 11.304676 -3.958739 14.771873 +5254 1342 4 0 10.819571 -4.657592 14.338362 +5255 1342 4 0 11.872243 -4.302988 15.497743 +5256 1343 6 0 0.810718 18.132291 -14.333312 +5257 1343 4 0 0.190255 17.471051 -14.607576 +5258 1343 4 0 1.665202 17.681600 -14.166677 +5259 1344 6 0 -18.194302 10.734237 20.288216 +5260 1344 4 0 -18.737476 10.008872 20.011140 +5261 1344 4 0 -18.413412 10.870765 21.217524 +5262 1345 6 0 -7.563142 -16.389647 8.034997 +5263 1345 4 0 -7.754897 -16.237987 7.073421 +5264 1345 4 0 -8.386855 -16.715419 8.384876 +5265 1346 6 0 13.912058 -6.782117 15.996328 +5266 1346 4 0 13.180027 -7.276194 16.277557 +5267 1346 4 0 13.861231 -6.438577 15.112401 +5268 1347 6 0 -25.429958 -6.548345 16.184656 +5269 1347 4 0 -24.780220 -7.006450 16.697079 +5270 1347 4 0 -26.340485 -6.934525 16.332424 +5271 1348 6 0 -25.500783 -16.025799 -9.490569 +5272 1348 4 0 -26.164448 -16.158413 -8.820769 +5273 1348 4 0 -25.951236 -16.456932 -10.263221 +5274 1349 6 0 24.124222 2.121712 -16.465144 +5275 1349 4 0 24.497335 2.845246 -17.081218 +5276 1349 4 0 24.792485 1.399163 -16.373949 +5277 1350 6 0 4.547327 -7.471124 19.146289 +5278 1350 4 0 4.354864 -7.322111 18.216109 +5279 1350 4 0 3.632016 -7.470487 19.500477 +5280 1351 6 0 10.120616 17.236092 14.316409 +5281 1351 4 0 10.306027 17.503867 15.195486 +5282 1351 4 0 9.503499 17.802179 13.861569 +5283 1352 6 0 21.443686 -0.137574 -7.240239 +5284 1352 4 0 21.320909 -0.780264 -6.543039 +5285 1352 4 0 20.520021 0.052046 -7.411757 +5286 1353 6 0 -18.828207 -17.795055 12.603944 +5287 1353 4 0 -19.462622 -18.118613 13.289732 +5288 1353 4 0 -19.239011 -18.165303 11.770846 +5289 1354 6 0 -5.408698 18.602640 19.942387 +5290 1354 4 0 -4.940011 19.368098 19.546138 +5291 1354 4 0 -4.701861 17.940803 20.028319 +5292 1355 6 0 1.246630 7.058463 14.491223 +5293 1355 4 0 1.833210 6.855645 13.673367 +5294 1355 4 0 1.409024 6.330352 15.131330 +5295 1356 6 0 12.743100 -19.137500 -10.658143 +5296 1356 4 0 12.731029 -19.861558 -11.325766 +5297 1356 4 0 13.636140 -18.849862 -10.621111 +5298 1357 6 0 8.176227 18.621713 -14.093293 +5299 1357 4 0 8.403415 17.666902 -14.107193 +5300 1357 4 0 8.904018 18.994347 -14.634670 +5301 1358 6 0 -2.850169 -13.873152 15.306117 +5302 1358 4 0 -2.778021 -14.417883 14.515219 +5303 1358 4 0 -2.855607 -12.985119 14.927436 +5304 1359 6 0 -2.292558 -20.012333 10.080992 +5305 1359 4 0 -1.651194 -19.572426 10.625999 +5306 1359 4 0 -2.187742 -19.593458 9.218576 +5307 1360 6 0 22.331247 5.799873 2.670280 +5308 1360 4 0 22.434189 5.666649 3.628261 +5309 1360 4 0 22.776307 5.021312 2.347574 +5310 1361 6 0 15.417762 16.217823 -20.022192 +5311 1361 4 0 14.476316 16.148202 -19.889414 +5312 1361 4 0 15.596696 16.629517 -20.930968 +5313 1362 6 0 -26.290384 -0.615609 -8.011370 +5314 1362 4 0 -26.337180 -1.338819 -7.375398 +5315 1362 4 0 -27.197456 -0.506091 -8.331222 +5316 1363 6 0 9.027104 -10.649673 18.216586 +5317 1363 4 0 9.003116 -9.685060 18.321463 +5318 1363 4 0 8.395635 -11.040516 18.879208 +5319 1364 6 0 20.540085 20.400943 18.176526 +5320 1364 4 0 21.096121 20.661895 18.908831 +5321 1364 4 0 19.896888 21.145098 18.113813 +5322 1365 6 0 -1.026820 14.710767 -4.091506 +5323 1365 4 0 -1.483470 15.499879 -3.851169 +5324 1365 4 0 -1.334746 14.285611 -4.859625 +5325 1366 6 0 -26.089489 15.380454 18.855264 +5326 1366 4 0 -25.115552 15.260124 18.557693 +5327 1366 4 0 -26.107913 15.393677 19.825673 +5328 1367 6 0 2.007574 -16.086893 18.910154 +5329 1367 4 0 2.169938 -15.300051 18.371811 +5330 1367 4 0 1.765349 -16.777501 18.309170 +5331 1368 6 0 -1.731416 -1.209658 -17.616026 +5332 1368 4 0 -1.627324 -2.121913 -17.876677 +5333 1368 4 0 -0.897064 -0.759027 -17.856313 +5334 1369 6 0 -7.458988 -9.905611 -19.067646 +5335 1369 4 0 -7.612323 -9.236466 -18.379766 +5336 1369 4 0 -6.775597 -10.433737 -18.660285 +5337 1370 6 0 24.628885 -15.762187 -8.892475 +5338 1370 4 0 24.465618 -16.362594 -8.154270 +5339 1370 4 0 25.428263 -15.265529 -8.789821 +5340 1371 6 0 21.341678 17.087622 -2.433709 +5341 1371 4 0 22.027154 16.590055 -2.017304 +5342 1371 4 0 20.972791 17.595736 -1.703682 +5343 1372 6 0 11.041731 -1.458544 17.027146 +5344 1372 4 0 11.616990 -0.777488 17.323484 +5345 1372 4 0 11.529032 -2.030322 16.345409 +5346 1373 6 0 20.352182 -20.640448 -2.038220 +5347 1373 4 0 20.706451 -20.927732 -2.854198 +5348 1373 4 0 21.078721 -20.655585 -1.410115 +5349 1374 6 0 2.118915 -12.215325 -19.313844 +5350 1374 4 0 1.412292 -12.890446 -19.223921 +5351 1374 4 0 2.971726 -12.642687 -19.466619 +5352 1375 6 0 -18.234007 -11.608978 -6.453902 +5353 1375 4 0 -18.824060 -11.919205 -5.748304 +5354 1375 4 0 -17.399503 -12.148958 -6.321644 +5355 1376 6 0 12.956287 4.319222 -3.994225 +5356 1376 4 0 12.213046 3.674862 -3.908399 +5357 1376 4 0 12.579678 5.119154 -3.559136 +5358 1377 6 0 -16.653199 5.258818 18.455342 +5359 1377 4 0 -17.496007 5.121615 18.892108 +5360 1377 4 0 -16.041443 5.030868 19.126227 +5361 1378 6 0 10.499124 9.233410 -20.179160 +5362 1378 4 0 10.147585 9.358107 -19.280974 +5363 1378 4 0 11.442853 9.276973 -20.041862 +5364 1379 6 0 0.510441 -0.870953 17.320417 +5365 1379 4 0 1.102755 -1.566191 17.515002 +5366 1379 4 0 0.955429 -0.019852 17.557716 +5367 1380 6 0 4.110276 5.067141 6.431077 +5368 1380 4 0 4.761963 4.437776 6.681941 +5369 1380 4 0 4.337595 5.795548 6.948690 +5370 1381 6 0 11.452671 -16.505838 0.173069 +5371 1381 4 0 11.303683 -15.607972 0.510340 +5372 1381 4 0 12.391250 -16.653982 0.330533 +5373 1382 6 0 7.430077 -20.350208 8.105888 +5374 1382 4 0 7.675587 -20.672677 7.187383 +5375 1382 4 0 8.248925 -20.047358 8.520026 +5376 1383 6 0 -7.400434 16.364237 -16.666884 +5377 1383 4 0 -8.382471 16.160840 -16.727806 +5378 1383 4 0 -7.133812 16.815236 -17.541828 +5379 1384 6 0 -24.060814 19.512535 -2.061658 +5380 1384 4 0 -23.130977 19.418843 -1.893643 +5381 1384 4 0 -24.267554 20.363324 -2.551066 +5382 1385 6 0 20.387077 -17.871252 -2.506384 +5383 1385 4 0 19.459013 -17.739929 -2.640716 +5384 1385 4 0 20.424417 -18.802885 -2.422640 +5385 1386 6 0 -9.102927 -20.662897 -0.744511 +5386 1386 4 0 -8.351458 -20.647416 -0.154773 +5387 1386 4 0 -8.808769 -19.943254 -1.313754 +5388 1387 6 0 -22.416841 -13.711743 -11.454147 +5389 1387 4 0 -22.023904 -14.600414 -11.267420 +5390 1387 4 0 -21.766795 -13.100859 -11.064675 +5391 1388 6 0 18.020659 1.320207 -14.873666 +5392 1388 4 0 17.072103 1.602050 -14.789845 +5393 1388 4 0 18.329426 1.503733 -13.971877 +5394 1389 6 0 -15.611967 -16.933927 -20.034244 +5395 1389 4 0 -15.697544 -15.974880 -19.912529 +5396 1389 4 0 -16.463764 -17.241305 -19.666078 +5397 1390 6 0 -21.399563 -20.604313 -19.819242 +5398 1390 4 0 -22.286272 -20.451053 -20.149900 +5399 1390 4 0 -20.960242 -19.767241 -20.062136 +5400 1391 6 0 -14.873799 15.000585 15.755334 +5401 1391 4 0 -15.665375 14.566463 15.276438 +5402 1391 4 0 -15.221469 15.704608 16.223975 +5403 1392 6 0 -22.283717 17.924070 6.363117 +5404 1392 4 0 -22.326943 17.328611 7.088360 +5405 1392 4 0 -22.769780 17.540247 5.616208 +5406 1393 6 0 -4.518256 15.930815 -10.776370 +5407 1393 4 0 -3.722298 16.148281 -11.175263 +5408 1393 4 0 -4.440115 15.005875 -10.441712 +5409 1394 6 0 23.829242 -12.577808 -10.269253 +5410 1394 4 0 23.709620 -12.211859 -11.148216 +5411 1394 4 0 24.681269 -13.072156 -10.250620 +5412 1395 6 0 25.052401 -0.262291 -3.629356 +5413 1395 4 0 25.651051 -0.543026 -4.364585 +5414 1395 4 0 24.527612 0.474703 -4.021632 +5415 1396 6 0 14.329934 -16.440730 7.995977 +5416 1396 4 0 15.030052 -16.157725 7.466301 +5417 1396 4 0 13.674876 -16.863377 7.389073 +5418 1397 6 0 17.211657 20.746652 5.342912 +5419 1397 4 0 17.565761 20.264477 4.651199 +5420 1397 4 0 17.675222 21.576262 5.214762 +5421 1398 6 0 18.857835 10.961021 -18.198746 +5422 1398 4 0 18.582121 10.331224 -18.896135 +5423 1398 4 0 18.706900 11.843177 -18.451427 +5424 1399 6 0 7.806576 -0.529506 11.040094 +5425 1399 4 0 8.004288 -1.400200 11.405855 +5426 1399 4 0 8.516912 0.066000 11.339425 +5427 1400 6 0 -6.293411 -18.726760 -7.845237 +5428 1400 4 0 -6.910802 -18.996812 -8.589964 +5429 1400 4 0 -5.423066 -18.680010 -8.240732 +5430 1401 6 0 -1.265386 -18.351217 15.342196 +5431 1401 4 0 -0.978536 -17.941389 14.498149 +5432 1401 4 0 -1.776754 -19.060650 14.957444 +5433 1402 6 0 22.240898 5.630349 9.837319 +5434 1402 4 0 21.800731 4.901204 9.365178 +5435 1402 4 0 22.570414 6.163537 9.075972 +5436 1403 6 0 -21.322343 8.388055 9.072770 +5437 1403 4 0 -22.042357 8.964988 9.320991 +5438 1403 4 0 -21.568690 8.084477 8.201200 +5439 1404 6 0 -7.671244 -4.189475 20.344117 +5440 1404 4 0 -7.419567 -4.322104 19.418696 +5441 1404 4 0 -8.363860 -4.824728 20.370282 +5442 1405 6 0 -24.129456 16.739076 10.610161 +5443 1405 4 0 -24.547205 17.167468 11.404792 +5444 1405 4 0 -24.468711 15.757636 10.582819 +5445 1406 6 0 -6.867333 -14.186985 10.119152 +5446 1406 4 0 -6.049023 -14.321450 10.601875 +5447 1406 4 0 -7.023306 -14.804381 9.421465 +5448 1407 6 0 27.346506 -3.270333 -16.312802 +5449 1407 4 0 28.255175 -3.592935 -16.275175 +5450 1407 4 0 27.317511 -2.474622 -16.807450 +5451 1408 6 0 -21.641506 5.727852 -20.459813 +5452 1408 4 0 -22.279373 6.214532 -21.053396 +5453 1408 4 0 -20.775787 6.025886 -20.684218 +5454 1409 6 0 25.309710 5.144361 4.524619 +5455 1409 4 0 25.816635 5.036211 5.343240 +5456 1409 4 0 24.410878 4.895458 4.808645 +5457 1410 6 0 -14.509617 -6.262805 19.159506 +5458 1410 4 0 -14.342716 -6.722944 19.988985 +5459 1410 4 0 -14.602416 -5.323286 19.288859 +5460 1411 6 0 -5.343448 -11.274271 19.025798 +5461 1411 4 0 -4.940638 -11.918950 18.424498 +5462 1411 4 0 -5.498793 -11.715720 19.830266 +5463 1412 6 0 -12.848588 -13.590248 17.033609 +5464 1412 4 0 -13.088575 -13.796556 16.123304 +5465 1412 4 0 -11.991420 -14.074390 17.232742 +5466 1413 6 0 -7.289082 -17.381003 -5.549847 +5467 1413 4 0 -8.038865 -17.962440 -5.504293 +5468 1413 4 0 -6.970028 -17.592513 -6.445260 +5469 1414 6 0 19.348721 -14.932661 19.813219 +5470 1414 4 0 19.577232 -15.858745 19.765206 +5471 1414 4 0 18.713188 -14.720751 20.514547 +5472 1415 6 0 -7.930616 -15.106164 -4.397641 +5473 1415 4 0 -8.445836 -14.519877 -4.885728 +5474 1415 4 0 -7.532499 -15.797439 -4.932460 +5475 1416 6 0 9.305997 -17.229888 -1.625877 +5476 1416 4 0 9.781891 -17.999835 -2.038321 +5477 1416 4 0 10.027236 -16.701835 -1.179404 +5478 1417 6 0 14.485547 17.913855 14.273541 +5479 1417 4 0 13.775573 18.190913 13.687091 +5480 1417 4 0 15.292649 17.853242 13.696917 +5481 1418 6 0 -17.856749 -3.239166 18.728922 +5482 1418 4 0 -18.264266 -2.371813 18.585117 +5483 1418 4 0 -17.320266 -3.326693 17.906655 +5484 1419 6 0 11.415319 5.923359 -20.462324 +5485 1419 4 0 12.034713 5.464442 -19.848871 +5486 1419 4 0 10.982818 5.221175 -20.955049 +5487 1420 6 0 4.246715 -11.198844 16.227140 +5488 1420 4 0 4.054406 -10.449224 15.720401 +5489 1420 4 0 3.729643 -11.076561 16.998845 +5490 1421 6 0 17.668887 16.010513 -14.839435 +5491 1421 4 0 17.475048 15.032227 -14.810123 +5492 1421 4 0 17.201356 16.387530 -15.640949 +5493 1422 6 0 -18.492111 8.644500 -1.484673 +5494 1422 4 0 -18.325091 9.560921 -1.252627 +5495 1422 4 0 -19.325787 8.367546 -1.121513 +5496 1423 6 0 13.610401 12.947630 3.013371 +5497 1423 4 0 13.281039 12.533993 3.856655 +5498 1423 4 0 14.367204 13.456810 3.354976 +5499 1424 6 0 -16.423725 20.151070 -20.282392 +5500 1424 4 0 -15.764964 20.343494 -20.952998 +5501 1424 4 0 -17.250142 20.198658 -20.732026 +5502 1425 6 0 -3.989847 10.270724 -11.073966 +5503 1425 4 0 -3.495466 11.034119 -11.283995 +5504 1425 4 0 -4.624991 10.165649 -11.788271 +5505 1426 6 0 16.276806 2.440391 -0.575792 +5506 1426 4 0 15.765940 1.689695 -0.443195 +5507 1426 4 0 16.230870 2.461846 -1.548388 +5508 1427 6 0 16.582337 4.961920 -0.018366 +5509 1427 4 0 16.750405 4.953804 0.881833 +5510 1427 4 0 16.382476 4.092139 -0.296219 +5511 1428 6 0 -16.776801 -4.258809 -20.926631 +5512 1428 4 0 -16.876778 -3.694234 -21.711494 +5513 1428 4 0 -15.815010 -4.231038 -20.634779 +5514 1429 6 0 27.306315 1.909319 15.774251 +5515 1429 4 0 27.528797 1.213633 15.174474 +5516 1429 4 0 26.309168 1.894233 15.827646 +5517 1430 6 0 -25.977063 12.434586 -4.101907 +5518 1430 4 0 -25.419677 13.227991 -4.057872 +5519 1430 4 0 -25.558038 11.886611 -3.392245 +5520 1431 6 0 -8.917537 20.162429 18.906910 +5521 1431 4 0 -9.817722 20.516050 18.889155 +5522 1431 4 0 -8.402992 20.765622 18.322054 +5523 1432 6 0 2.036338 -3.225452 18.493289 +5524 1432 4 0 2.815627 -3.223614 19.047224 +5525 1432 4 0 1.451253 -3.554309 19.176609 +5526 1433 6 0 -10.943111 -16.939296 -15.943963 +5527 1433 4 0 -10.715338 -17.873691 -15.814810 +5528 1433 4 0 -11.411581 -16.839878 -16.774067 +5529 1434 6 0 5.983465 -15.296272 4.531445 +5530 1434 4 0 6.553908 -14.747320 5.130885 +5531 1434 4 0 6.297291 -16.216179 4.672680 +5532 1435 6 0 0.087877 -18.701863 10.933978 +5533 1435 4 0 0.685292 -18.178478 10.372593 +5534 1435 4 0 0.721975 -19.147274 11.528158 +5535 1436 6 0 -15.867197 20.628171 12.879631 +5536 1436 4 0 -14.941749 20.909539 13.127416 +5537 1436 4 0 -16.061214 21.005786 12.011063 +5538 1437 6 0 -15.031464 -1.955849 18.854814 +5539 1437 4 0 -15.381408 -1.375187 18.132775 +5540 1437 4 0 -15.567308 -1.774457 19.596007 +5541 1438 6 0 -5.713639 -18.898958 -11.393727 +5542 1438 4 0 -5.561092 -18.122829 -11.901780 +5543 1438 4 0 -5.027945 -19.039448 -10.715374 +5544 1439 6 0 10.351785 2.342628 9.137608 +5545 1439 4 0 10.219354 1.517524 8.764529 +5546 1439 4 0 9.579584 2.957546 9.024779 +5547 1440 6 0 9.614533 -0.976089 19.746830 +5548 1440 4 0 9.631955 -1.223467 18.785924 +5549 1440 4 0 10.037560 -1.819567 20.145752 +5550 1441 6 0 -25.737514 5.101092 17.496072 +5551 1441 4 0 -25.949189 4.771339 16.619275 +5552 1441 4 0 -25.460497 6.029342 17.333464 +5553 1442 6 0 27.098530 15.410179 3.235558 +5554 1442 4 0 27.365221 16.280617 3.273489 +5555 1442 4 0 27.777628 14.851248 3.682250 +5556 1443 6 0 -22.145578 -2.524811 -16.789026 +5557 1443 4 0 -22.476890 -1.687774 -16.973175 +5558 1443 4 0 -22.545487 -2.678464 -15.881093 +5559 1444 6 0 -20.038660 7.882073 -10.677168 +5560 1444 4 0 -20.786353 8.456789 -10.411968 +5561 1444 4 0 -20.303885 6.997195 -10.661212 +5562 1445 6 0 6.124673 -5.149502 -15.761404 +5563 1445 4 0 6.612667 -4.434874 -15.249053 +5564 1445 4 0 6.646658 -5.246066 -16.553355 +5565 1446 6 0 6.017362 -16.085801 -17.806752 +5566 1446 4 0 6.270539 -16.458116 -16.921098 +5567 1446 4 0 5.250388 -15.542937 -17.506389 +5568 1447 6 0 -9.374031 -17.523242 2.545572 +5569 1447 4 0 -8.487532 -17.678151 2.185352 +5570 1447 4 0 -9.361698 -17.695772 3.484410 +5571 1448 6 0 15.510564 11.705332 -9.223052 +5572 1448 4 0 15.764354 12.551003 -8.768718 +5573 1448 4 0 14.956013 11.971918 -9.941944 +5574 1449 6 0 -8.575937 17.703676 -4.431665 +5575 1449 4 0 -8.405924 17.883222 -3.539392 +5576 1449 4 0 -8.969679 16.778001 -4.495229 +5577 1450 6 0 -15.277037 20.916980 18.527990 +5578 1450 4 0 -14.557049 20.578200 18.029786 +5579 1450 4 0 -14.784644 21.516499 19.154300 +5580 1451 6 0 23.805081 -13.876618 -5.245218 +5581 1451 4 0 23.301003 -14.539959 -4.743943 +5582 1451 4 0 23.699048 -13.156658 -4.566103 +5583 1452 6 0 23.235009 0.659798 -11.019427 +5584 1452 4 0 23.356235 -0.020938 -10.331928 +5585 1452 4 0 23.922180 0.433479 -11.687400 +5586 1453 6 0 -17.846164 6.890268 -13.615475 +5587 1453 4 0 -18.227474 6.233852 -12.960353 +5588 1453 4 0 -17.502560 7.653333 -13.062645 +5589 1454 6 0 3.237690 6.611110 12.384611 +5590 1454 4 0 2.939622 6.791701 11.472608 +5591 1454 4 0 3.597050 5.706217 12.314107 +5592 1455 6 0 12.621261 19.151311 -10.788464 +5593 1455 4 0 12.568861 18.191071 -10.482080 +5594 1455 4 0 12.304890 19.095240 -11.710548 +5595 1456 6 0 15.189541 -3.590616 -0.359174 +5596 1456 4 0 15.402717 -3.225037 -1.223302 +5597 1456 4 0 15.977001 -4.068104 -0.090059 +5598 1457 6 0 -5.355594 -8.568333 19.641427 +5599 1457 4 0 -6.310615 -8.510356 19.969721 +5600 1457 4 0 -5.329970 -9.512642 19.277800 +5601 1458 6 0 6.365722 2.783749 -12.009649 +5602 1458 4 0 6.365749 3.750417 -12.183807 +5603 1458 4 0 5.965929 2.688579 -11.148102 +5604 1459 6 0 13.169614 -10.142007 -11.634557 +5605 1459 4 0 12.793149 -9.899166 -12.523960 +5606 1459 4 0 12.998542 -11.088881 -11.478349 +5607 1460 6 0 -22.674956 -9.666699 -16.999652 +5608 1460 4 0 -22.331812 -10.389941 -17.591652 +5609 1460 4 0 -22.299353 -8.906035 -17.478779 +5610 1461 6 0 -12.989714 14.562837 -4.489024 +5611 1461 4 0 -13.895012 14.141511 -4.581855 +5612 1461 4 0 -12.287469 13.906583 -4.558336 +5613 1462 6 0 11.889244 7.234465 -14.239933 +5614 1462 4 0 11.841540 6.403022 -13.699089 +5615 1462 4 0 11.297036 7.163549 -15.011709 +5616 1463 6 0 14.205425 -4.375072 6.885349 +5617 1463 4 0 14.444785 -3.467494 6.828421 +5618 1463 4 0 14.540396 -4.824463 6.047265 +5619 1464 6 0 14.238877 -11.199937 -5.844240 +5620 1464 4 0 14.336897 -11.151845 -6.791045 +5621 1464 4 0 14.161965 -12.124432 -5.730368 +5622 1465 6 0 16.419881 -8.263494 5.499713 +5623 1465 4 0 16.888087 -7.438031 5.380531 +5624 1465 4 0 16.938306 -8.794006 4.823282 +5625 1466 6 0 23.034740 17.150944 7.848428 +5626 1466 4 0 22.252785 17.491282 7.376162 +5627 1466 4 0 23.353461 18.012155 8.262400 +5628 1467 6 0 -3.250988 20.899767 -14.198279 +5629 1467 4 0 -3.536111 20.593819 -13.311678 +5630 1467 4 0 -2.238291 20.969313 -14.122183 +5631 1468 6 0 2.193864 -14.308738 -13.102332 +5632 1468 4 0 2.901120 -13.646677 -13.123464 +5633 1468 4 0 2.577942 -14.916050 -13.753214 +5634 1469 6 0 17.220878 14.344503 7.704982 +5635 1469 4 0 16.741444 14.217801 8.575501 +5636 1469 4 0 17.724190 13.489371 7.542738 +5637 1470 6 0 12.455324 8.941935 14.709279 +5638 1470 4 0 12.329532 7.965607 14.651692 +5639 1470 4 0 13.090154 8.950686 15.466000 +5640 1471 6 0 -12.573656 -3.849306 9.754915 +5641 1471 4 0 -11.774505 -4.059630 10.198532 +5642 1471 4 0 -13.177238 -3.385101 10.384533 +5643 1472 6 0 -3.160920 -11.557605 -13.637501 +5644 1472 4 0 -3.513108 -10.729378 -13.902906 +5645 1472 4 0 -2.423129 -11.640209 -14.202523 +5646 1473 6 0 0.173291 18.530627 4.588870 +5647 1473 4 0 0.366643 18.095665 3.775805 +5648 1473 4 0 0.528197 17.966406 5.256043 +5649 1474 6 0 -20.835824 0.618182 3.010345 +5650 1474 4 0 -21.714394 0.910710 2.556806 +5651 1474 4 0 -20.176134 1.018899 2.465288 +5652 1475 6 0 -5.819679 17.244537 -18.746988 +5653 1475 4 0 -4.895225 17.522561 -18.912967 +5654 1475 4 0 -5.875069 16.339088 -19.152521 +5655 1476 6 0 23.150756 6.504841 -18.289508 +5656 1476 4 0 23.185422 7.145655 -19.092606 +5657 1476 4 0 22.256620 6.278150 -18.023232 +5658 1477 6 0 11.077729 -17.823438 -12.637425 +5659 1477 4 0 11.305129 -18.418523 -13.399570 +5660 1477 4 0 11.718877 -18.045413 -11.962474 +5661 1478 6 0 -18.440076 4.089219 -20.233130 +5662 1478 4 0 -18.592368 4.508225 -19.389005 +5663 1478 4 0 -18.684565 4.808320 -20.850382 +5664 1479 6 0 -23.687711 -16.266769 -17.315735 +5665 1479 4 0 -23.698996 -15.631059 -16.558060 +5666 1479 4 0 -22.895860 -16.803598 -17.114489 +5667 1480 6 0 -12.383477 -18.880969 14.766217 +5668 1480 4 0 -12.124554 -18.562567 13.876588 +5669 1480 4 0 -11.797092 -18.625014 15.425543 +5670 1481 6 0 14.311125 11.668895 8.886321 +5671 1481 4 0 13.349519 11.381714 8.877659 +5672 1481 4 0 14.742001 11.037775 8.253125 +5673 1482 6 0 21.499156 2.133932 3.402465 +5674 1482 4 0 22.423113 2.229631 3.696856 +5675 1482 4 0 21.472059 1.349459 2.811378 +5676 1483 6 0 22.466695 -14.225899 -2.830703 +5677 1483 4 0 22.948700 -13.678947 -2.237715 +5678 1483 4 0 22.233121 -15.024736 -2.381007 +5679 1484 6 0 -17.714836 -8.402483 -11.856647 +5680 1484 4 0 -18.457906 -8.997855 -11.616200 +5681 1484 4 0 -16.950883 -8.800780 -11.389594 +5682 1485 6 0 -13.154395 20.875531 -1.901594 +5683 1485 4 0 -14.099007 20.684326 -1.676218 +5684 1485 4 0 -12.776951 21.273644 -1.137151 +5685 1486 6 0 10.058528 -10.804893 -19.659672 +5686 1486 4 0 10.024212 -10.944820 -18.690131 +5687 1486 4 0 9.262507 -10.364334 -19.857371 +5688 1487 6 0 24.206149 -6.530273 6.651758 +5689 1487 4 0 23.298132 -6.779979 6.469418 +5690 1487 4 0 24.435964 -6.280937 7.532499 +5691 1488 6 0 -0.769539 13.370711 18.754750 +5692 1488 4 0 -1.399471 13.295369 18.002641 +5693 1488 4 0 -1.282846 13.503163 19.578024 +5694 1489 6 0 12.489489 -16.824385 17.447916 +5695 1489 4 0 12.052693 -16.106503 17.961272 +5696 1489 4 0 12.979700 -17.322750 18.119196 +5697 1490 6 0 22.391449 -7.947848 18.889943 +5698 1490 4 0 22.777744 -7.558109 18.080179 +5699 1490 4 0 21.582771 -8.396208 18.531967 +5700 1491 6 0 24.444175 12.917036 5.832052 +5701 1491 4 0 24.511172 13.835523 6.045623 +5702 1491 4 0 23.797849 12.920835 5.128292 +5703 1492 6 0 13.404469 11.238393 -13.308046 +5704 1492 4 0 13.712479 10.420163 -13.763288 +5705 1492 4 0 12.688252 10.856036 -12.768343 +5706 1493 6 0 20.968072 -7.216860 -20.774585 +5707 1493 4 0 21.500932 -6.797898 -20.085206 +5708 1493 4 0 21.506305 -7.089210 -21.583804 +5709 1494 6 0 -17.856365 -7.389334 -15.755928 +5710 1494 4 0 -17.779099 -7.695814 -16.681187 +5711 1494 4 0 -17.454778 -6.543622 -15.646073 +5712 1495 6 0 -5.627767 -14.791821 -18.435422 +5713 1495 4 0 -6.515410 -14.559760 -18.598093 +5714 1495 4 0 -5.318446 -15.164242 -19.264852 +5715 1496 6 0 2.656405 -0.176950 -14.262302 +5716 1496 4 0 2.534896 -0.323212 -15.231477 +5717 1496 4 0 3.447328 0.360291 -14.052654 +5718 1497 6 0 -26.736151 5.658653 0.855763 +5719 1497 4 0 -25.877403 5.925247 0.635025 +5720 1497 4 0 -26.753355 4.689074 0.832778 +5721 1498 6 0 -8.652434 19.947608 -11.265190 +5722 1498 4 0 -8.042720 19.800388 -11.992106 +5723 1498 4 0 -8.377500 20.767189 -10.778181 +5724 1499 6 0 3.645772 -16.139913 -20.354692 +5725 1499 4 0 3.723824 -17.050742 -20.075710 +5726 1499 4 0 3.139128 -16.051183 -21.192748 +5727 1500 6 0 2.751218 19.096756 -12.278055 +5728 1500 4 0 3.589100 18.687062 -12.053483 +5729 1500 4 0 2.907368 19.432717 -13.149786 +5730 1501 6 0 11.895340 -6.132227 -17.645418 +5731 1501 4 0 12.272195 -6.990163 -17.614612 +5732 1501 4 0 12.522919 -5.533948 -18.055179 +5733 1502 6 0 -2.649062 -11.532506 14.303842 +5734 1502 4 0 -2.171418 -10.788172 14.727655 +5735 1502 4 0 -3.444108 -11.118837 14.016513 +5736 1503 6 0 0.083662 -17.539610 -9.794080 +5737 1503 4 0 0.925887 -17.184555 -10.098352 +5738 1503 4 0 0.064605 -17.230344 -8.891803 +5739 1504 6 0 -23.495878 -18.174487 -3.096140 +5740 1504 4 0 -23.397765 -18.550076 -2.214521 +5741 1504 4 0 -23.991094 -18.883389 -3.445375 +5742 1505 6 0 -2.870665 -20.299637 3.495989 +5743 1505 4 0 -2.025936 -20.316623 2.990845 +5744 1505 4 0 -2.887489 -19.480343 3.955086 +5745 1506 6 0 -23.237675 -7.968838 11.601659 +5746 1506 4 0 -23.646989 -7.664067 12.406714 +5747 1506 4 0 -22.916603 -8.875240 11.799352 +5748 1507 6 0 7.034857 17.671926 16.668461 +5749 1507 4 0 6.910916 17.021535 17.353714 +5750 1507 4 0 7.298259 17.003434 15.931912 +5751 1508 6 0 -3.135847 -0.037211 -19.720235 +5752 1508 4 0 -2.687204 -0.465713 -19.004635 +5753 1508 4 0 -3.883189 -0.596483 -19.830762 +5754 1509 6 0 -4.116282 9.933467 -15.972432 +5755 1509 4 0 -4.382486 10.098448 -16.874934 +5756 1509 4 0 -3.276586 10.322141 -15.857331 +5757 1510 6 0 9.001776 -2.037724 13.845066 +5758 1510 4 0 9.557925 -2.591779 14.385639 +5759 1510 4 0 8.707709 -2.619965 13.087293 +5760 1511 6 0 -14.291358 -16.357375 0.136544 +5761 1511 4 0 -14.623350 -16.546154 1.040530 +5762 1511 4 0 -13.337866 -16.185545 0.296606 +5763 1512 6 0 -8.307685 7.831957 -19.053875 +5764 1512 4 0 -8.711204 7.493084 -18.235703 +5765 1512 4 0 -7.891044 8.658915 -18.717398 +5766 1513 6 0 20.987462 12.906787 9.958048 +5767 1513 4 0 21.435148 12.305385 10.516693 +5768 1513 4 0 21.330938 12.746483 9.110616 +5769 1514 6 0 24.845310 0.514421 -13.306188 +5770 1514 4 0 24.715007 0.071792 -14.155230 +5771 1514 4 0 25.044193 1.459969 -13.507156 +5772 1515 6 0 9.940414 -19.224463 8.285169 +5773 1515 4 0 10.344194 -19.951358 7.833443 +5774 1515 4 0 9.604359 -18.739761 7.480563 +5775 1516 6 0 -21.714063 9.254293 -18.084261 +5776 1516 4 0 -21.666348 10.112348 -18.429358 +5777 1516 4 0 -20.881272 8.819770 -18.352190 +5778 1517 6 0 -7.191585 20.361392 -7.614111 +5779 1517 4 0 -7.827974 20.909525 -8.157675 +5780 1517 4 0 -7.763622 19.592347 -7.497909 +5781 1518 6 0 7.492921 13.497090 -0.820023 +5782 1518 4 0 7.499014 13.132441 -1.738485 +5783 1518 4 0 8.327452 13.163732 -0.446731 +5784 1519 6 0 9.961122 -18.299786 1.611143 +5785 1519 4 0 10.342232 -17.763270 0.893187 +5786 1519 4 0 9.632169 -19.079234 1.161105 +5787 1520 6 0 27.327916 14.167474 11.338410 +5788 1520 4 0 27.056501 14.797382 10.658423 +5789 1520 4 0 26.973899 14.521349 12.195671 +5790 1521 6 0 25.841592 -10.137073 17.886653 +5791 1521 4 0 26.549845 -10.744837 17.581594 +5792 1521 4 0 26.136382 -9.297891 18.115726 +5793 1522 6 0 -26.484582 -7.570640 0.220618 +5794 1522 4 0 -25.957551 -8.034324 0.885908 +5795 1522 4 0 -27.278989 -8.010770 0.092994 +5796 1523 6 0 -15.507886 -14.234567 -19.185887 +5797 1523 4 0 -16.428047 -14.062315 -19.146906 +5798 1523 4 0 -15.141693 -13.449414 -19.706261 +5799 1524 6 0 19.398920 -6.403154 -4.265132 +5800 1524 4 0 18.793855 -6.981438 -4.692992 +5801 1524 4 0 20.078652 -7.004436 -3.840081 +5802 1525 6 0 -14.727762 -11.689529 10.739544 +5803 1525 4 0 -15.118028 -11.677285 11.572442 +5804 1525 4 0 -15.363496 -11.211251 10.219303 +5805 1526 6 0 -10.164834 -13.429658 -5.821471 +5806 1526 4 0 -10.898604 -13.964191 -5.277591 +5807 1526 4 0 -10.251403 -12.561784 -5.414595 +5808 1527 6 0 17.930460 13.937399 -7.632026 +5809 1527 4 0 17.350338 14.712619 -7.873504 +5810 1527 4 0 17.573194 13.449935 -6.914302 +5811 1528 6 0 22.771963 11.789723 -15.991841 +5812 1528 4 0 22.407892 10.960756 -15.803516 +5813 1528 4 0 23.728244 11.844157 -15.970852 +5814 1529 6 0 -27.022171 -9.935535 -1.551898 +5815 1529 4 0 -26.648537 -9.163079 -1.958000 +5816 1529 4 0 -27.147733 -10.561946 -2.264608 +5817 1530 6 0 -25.271131 5.141749 -12.209736 +5818 1530 4 0 -25.693109 5.472145 -11.442865 +5819 1530 4 0 -24.406635 4.695966 -11.908321 +5820 1531 6 0 3.108121 -20.428019 2.767972 +5821 1531 4 0 2.883888 -19.516039 2.682074 +5822 1531 4 0 2.524652 -20.911289 2.151071 +5823 1532 6 0 13.645477 -11.248379 -2.168699 +5824 1532 4 0 14.495812 -10.982395 -1.919860 +5825 1532 4 0 13.602764 -10.946321 -3.131943 +5826 1533 6 0 -15.802101 -18.826697 -13.646876 +5827 1533 4 0 -15.629728 -18.718460 -14.634045 +5828 1533 4 0 -16.312937 -19.607220 -13.527508 +5829 1534 6 0 16.994190 -18.162501 0.782551 +5830 1534 4 0 16.183512 -18.419341 1.225144 +5831 1534 4 0 17.692383 -18.785460 1.112617 +5832 1535 6 0 0.346250 -8.244458 13.026523 +5833 1535 4 0 -0.056728 -8.794215 13.707605 +5834 1535 4 0 0.196186 -7.378794 13.513605 +5835 1536 6 0 -5.876633 -1.250758 16.950150 +5836 1536 4 0 -5.897139 -0.851532 16.048115 +5837 1536 4 0 -6.813697 -1.215101 17.207829 +5838 1537 6 0 -2.852852 -1.916845 15.179008 +5839 1537 4 0 -3.068812 -1.830206 16.106831 +5840 1537 4 0 -3.640384 -2.245054 14.797756 +5841 1538 6 0 -25.940841 -4.816621 -4.070316 +5842 1538 4 0 -25.207622 -5.264430 -3.620016 +5843 1538 4 0 -26.649933 -4.717697 -3.451686 +5844 1539 6 0 4.874827 1.473886 -14.337797 +5845 1539 4 0 5.189548 1.046518 -15.146140 +5846 1539 4 0 5.658759 1.677209 -13.804635 +5847 1540 6 0 -11.399492 -17.545168 -11.709535 +5848 1540 4 0 -10.632696 -17.968067 -12.065761 +5849 1540 4 0 -11.990484 -18.281339 -11.463174 +5850 1541 6 0 -21.235393 3.531686 -18.981903 +5851 1541 4 0 -20.811243 2.725219 -19.355158 +5852 1541 4 0 -21.330003 4.199180 -19.707403 +5853 1542 6 0 19.884738 13.457886 -16.503712 +5854 1542 4 0 20.546443 14.081854 -16.252605 +5855 1542 4 0 19.863325 12.725299 -15.889148 +5856 1543 6 0 -7.613490 -18.734979 -2.286157 +5857 1543 4 0 -7.224353 -19.383742 -2.870642 +5858 1543 4 0 -7.258594 -17.884019 -2.571812 +5859 1544 6 0 20.179247 18.669512 -9.520770 +5860 1544 4 0 19.745104 19.383705 -9.949059 +5861 1544 4 0 21.106271 18.888549 -9.619590 +5862 1545 6 0 0.469489 5.800556 -16.240608 +5863 1545 4 0 0.192512 6.630216 -16.696807 +5864 1545 4 0 0.599388 6.155641 -15.380452 +5865 1546 6 0 6.877961 19.550178 -9.988757 +5866 1546 4 0 6.368993 19.971864 -9.244013 +5867 1546 4 0 6.518231 19.965222 -10.851986 +5868 1547 6 0 6.720059 20.276251 -3.381777 +5869 1547 4 0 5.891426 20.783054 -3.333942 +5870 1547 4 0 6.919774 20.067477 -2.473444 +5871 1548 6 0 22.013148 -15.969229 12.266907 +5872 1548 4 0 21.416898 -16.484884 11.623216 +5873 1548 4 0 22.857478 -16.358079 12.000305 +5874 1549 6 0 -15.694438 7.944675 2.647767 +5875 1549 4 0 -15.370792 7.967212 3.559417 +5876 1549 4 0 -15.467715 7.066496 2.332465 +5877 1550 6 0 -25.016666 -19.872056 -7.507112 +5878 1550 4 0 -24.041389 -19.998563 -7.476847 +5879 1550 4 0 -25.261819 -19.677629 -8.458935 +5880 1551 6 0 -17.404966 16.289559 0.378862 +5881 1551 4 0 -17.816202 15.395796 0.469359 +5882 1551 4 0 -16.592061 16.078371 -0.128857 +5883 1552 6 0 11.719854 13.896915 -20.007550 +5884 1552 4 0 11.762017 13.509054 -20.946443 +5885 1552 4 0 11.730057 13.211150 -19.340581 +5886 1553 6 0 -21.635289 10.922735 -14.289364 +5887 1553 4 0 -22.250180 11.585121 -14.648600 +5888 1553 4 0 -20.920683 10.786571 -14.961527 +5889 1554 6 0 -24.042065 -5.374879 10.098466 +5890 1554 4 0 -23.939428 -5.512490 9.105496 +5891 1554 4 0 -23.970753 -6.321333 10.460122 +5892 1555 6 0 -9.411597 6.559490 -16.669992 +5893 1555 4 0 -10.312323 6.551498 -16.403482 +5894 1555 4 0 -9.011995 5.640085 -16.634798 +5895 1556 6 0 9.530893 -11.884062 12.046782 +5896 1556 4 0 9.879650 -11.398694 11.280896 +5897 1556 4 0 9.261341 -11.231618 12.651989 +5898 1557 6 0 -1.911349 -16.933894 1.374617 +5899 1557 4 0 -2.219904 -17.739022 1.023023 +5900 1557 4 0 -1.747381 -16.334388 0.676612 +5901 1558 6 0 26.179381 -17.174136 0.502901 +5902 1558 4 0 25.703357 -17.150578 -0.364558 +5903 1558 4 0 25.879759 -16.529513 1.122222 +5904 1559 6 0 23.006008 2.418768 11.548952 +5905 1559 4 0 22.123244 2.196506 11.872833 +5906 1559 4 0 22.916266 2.423276 10.570078 +5907 1560 6 0 -25.061378 12.895337 -10.920642 +5908 1560 4 0 -24.236859 12.794849 -10.380539 +5909 1560 4 0 -24.844809 13.124176 -11.856801 +5910 1561 6 0 24.065450 16.186345 -1.562209 +5911 1561 4 0 23.818077 16.816733 -0.921419 +5912 1561 4 0 24.446065 16.798992 -2.179306 +5913 1562 6 0 21.877525 -11.997066 12.743827 +5914 1562 4 0 21.110101 -12.307846 12.276099 +5915 1562 4 0 21.795852 -11.028569 12.668947 +5916 1563 6 0 -9.770390 12.275988 6.625277 +5917 1563 4 0 -9.540551 11.529014 6.118639 +5918 1563 4 0 -9.063347 12.943993 6.639152 +5919 1564 6 0 7.590434 -16.518614 -3.885689 +5920 1564 4 0 8.245405 -16.780602 -4.602660 +5921 1564 4 0 8.060783 -16.730529 -3.006396 +5922 1565 6 0 -8.819809 7.819937 16.686859 +5923 1565 4 0 -8.459184 7.862962 15.781131 +5924 1565 4 0 -8.333215 7.208627 17.206742 +5925 1566 6 0 -0.018770 12.851916 7.726452 +5926 1566 4 0 -0.018534 13.815629 7.654360 +5927 1566 4 0 -0.678950 12.568762 8.379340 +5928 1567 6 0 26.935998 -2.260542 -4.734090 +5929 1567 4 0 27.692757 -2.309847 -5.350797 +5930 1567 4 0 27.186636 -2.518573 -3.802021 +5931 1568 6 0 27.034878 8.922183 -3.893061 +5932 1568 4 0 26.315953 9.520583 -3.776301 +5933 1568 4 0 27.485194 9.316156 -4.684455 +5934 1569 6 0 8.051349 7.651612 -11.998393 +5935 1569 4 0 8.628507 7.928025 -11.260450 +5936 1569 4 0 7.748144 8.473350 -12.355271 +5937 1570 6 0 -27.116258 -14.053521 12.105107 +5938 1570 4 0 -27.545532 -13.197780 12.384888 +5939 1570 4 0 -26.358772 -13.875946 11.579879 +5940 1571 6 0 23.554783 -11.406323 -3.754207 +5941 1571 4 0 24.096179 -11.152033 -2.997418 +5942 1571 4 0 23.941749 -11.074873 -4.532762 +5943 1572 6 0 -6.910654 -17.603975 17.334387 +5944 1572 4 0 -7.702761 -17.167889 17.745512 +5945 1572 4 0 -6.836320 -17.171292 16.454588 +5946 1573 6 0 -16.492037 5.302939 -1.579501 +5947 1573 4 0 -16.042514 4.646869 -2.112816 +5948 1573 4 0 -15.801804 6.017062 -1.587499 +5949 1574 6 0 -23.756350 3.926953 -8.179925 +5950 1574 4 0 -23.195167 4.286584 -8.893370 +5951 1574 4 0 -23.460247 3.034235 -7.983373 +5952 1575 6 0 -13.747357 8.818643 -3.799589 +5953 1575 4 0 -13.952688 8.414506 -2.934484 +5954 1575 4 0 -13.853214 9.757832 -3.600478 +5955 1576 6 0 -1.628128 -12.816264 -17.331527 +5956 1576 4 0 -2.433523 -13.356344 -17.119883 +5957 1576 4 0 -2.044696 -11.950129 -17.560931 +5958 1577 6 0 -0.085635 15.544048 -1.201911 +5959 1577 4 0 -0.000781 16.405004 -1.546695 +5960 1577 4 0 -0.971991 15.289121 -0.919162 +5961 1578 6 0 -8.590554 17.067218 -10.033341 +5962 1578 4 0 -8.478641 17.979748 -10.381694 +5963 1578 4 0 -9.177179 16.660222 -10.710438 +5964 1579 6 0 -18.092032 -16.862277 -18.860686 +5965 1579 4 0 -17.787112 -16.936281 -17.986509 +5966 1579 4 0 -18.687545 -17.567560 -19.061403 +5967 1580 6 0 11.369215 4.413430 15.924887 +5968 1580 4 0 11.372520 3.624729 15.359827 +5969 1580 4 0 11.705477 5.119414 15.321428 +5970 1581 6 0 12.784492 7.071253 19.464041 +5971 1581 4 0 12.860418 6.279814 18.965525 +5972 1581 4 0 12.277088 6.716268 20.219705 +5973 1582 6 0 12.068135 -8.262908 17.552171 +5974 1582 4 0 11.944483 -7.791072 18.350772 +5975 1582 4 0 12.525141 -9.091659 17.770424 +5976 1583 6 0 10.241854 4.742923 2.559332 +5977 1583 4 0 9.423895 4.504759 2.987600 +5978 1583 4 0 10.968724 4.120073 2.820528 +5979 1584 6 0 4.587851 -5.032891 12.160556 +5980 1584 4 0 4.431505 -4.242508 12.621627 +5981 1584 4 0 5.402359 -4.988575 11.647199 +5982 1585 6 0 -24.230874 -6.577818 -16.070853 +5983 1585 4 0 -23.682020 -6.608606 -15.296098 +5984 1585 4 0 -25.097764 -7.040376 -15.909446 +5985 1586 6 0 20.182613 7.158966 1.874949 +5986 1586 4 0 20.915498 6.541606 2.146531 +5987 1586 4 0 20.710894 7.927513 1.477203 +5988 1587 6 0 21.755390 6.896132 -12.917138 +5989 1587 4 0 22.076449 7.236600 -12.089303 +5990 1587 4 0 22.525120 6.527089 -13.344666 +5991 1588 6 0 6.877822 -4.771079 6.941634 +5992 1588 4 0 7.368474 -3.917167 6.794895 +5993 1588 4 0 6.561555 -4.815923 7.876455 +5994 1589 6 0 -17.794941 18.359853 16.305117 +5995 1589 4 0 -18.421394 18.650198 16.927781 +5996 1589 4 0 -17.650629 19.254815 15.811542 +5997 1590 6 0 -2.602624 -16.412046 -10.596632 +5998 1590 4 0 -2.730413 -15.479270 -10.244360 +5999 1590 4 0 -1.636947 -16.665956 -10.610129 +6000 1591 6 0 3.935143 -2.077202 16.379950 +6001 1591 4 0 3.116180 -2.074570 16.871393 +6002 1591 4 0 4.258130 -3.011541 16.214763 +6003 1592 6 0 26.054987 14.635245 18.309718 +6004 1592 4 0 27.012144 14.531484 18.422001 +6005 1592 4 0 25.883129 15.612156 18.232382 +6006 1593 6 0 22.186055 -2.285036 -18.276384 +6007 1593 4 0 22.575561 -1.490206 -18.592190 +6008 1593 4 0 21.774977 -1.952262 -17.452519 +6009 1594 6 0 5.982701 12.874655 -19.536076 +6010 1594 4 0 6.160786 13.198075 -20.428652 +6011 1594 4 0 6.854019 12.668623 -19.180374 +6012 1595 6 0 -6.054158 -13.744402 -7.200732 +6013 1595 4 0 -6.689102 -14.438760 -7.467162 +6014 1595 4 0 -5.241683 -14.218938 -7.253580 +6015 1596 6 0 7.766648 -19.472206 -8.674412 +6016 1596 4 0 7.994143 -19.850740 -7.811770 +6017 1596 4 0 7.159819 -20.051349 -9.144842 +6018 1597 6 0 -13.899693 -2.310609 11.719170 +6019 1597 4 0 -14.293895 -1.540339 11.338780 +6020 1597 4 0 -13.136046 -1.840341 12.108102 +6021 1598 6 0 26.880118 -3.988040 -2.564260 +6022 1598 4 0 27.141785 -3.912376 -1.619664 +6023 1598 4 0 25.991507 -4.403119 -2.509330 +6024 1599 6 0 16.831698 -0.370079 16.786168 +6025 1599 4 0 17.550555 0.178386 16.456695 +6026 1599 4 0 17.096485 -0.465948 17.715552 +6027 1600 6 0 19.019953 8.994801 17.672825 +6028 1600 4 0 18.825567 9.927341 17.839722 +6029 1600 4 0 19.072225 8.455310 18.528449 +6030 1601 6 0 -23.890734 -17.531047 20.103131 +6031 1601 4 0 -24.410048 -17.249588 20.880036 +6032 1601 4 0 -23.243461 -16.838233 19.952601 +6033 1602 6 0 24.612082 6.311703 -14.314049 +6034 1602 4 0 24.685511 6.721117 -15.194578 +6035 1602 4 0 24.456182 5.357259 -14.330432 +6036 1603 6 0 11.630912 5.335794 8.212450 +6037 1603 4 0 10.744689 5.096999 8.355771 +6038 1603 4 0 11.632399 6.142908 7.660144 +6039 1604 6 0 16.482829 -7.676138 17.246704 +6040 1604 4 0 15.832973 -7.172968 16.764273 +6041 1604 4 0 17.323015 -7.087522 17.068424 +6042 1605 6 0 -14.246850 -1.445493 8.521283 +6043 1605 4 0 -14.965431 -1.234868 9.098827 +6044 1605 4 0 -14.565647 -2.243574 8.052945 +6045 1606 6 0 -12.243735 5.878745 14.287709 +6046 1606 4 0 -12.931194 5.878071 14.927194 +6047 1606 4 0 -12.476832 5.118118 13.758795 +6048 1607 6 0 14.365931 -20.845025 6.067181 +6049 1607 4 0 14.538057 -20.237448 6.808442 +6050 1607 4 0 15.204917 -21.078698 5.761047 +6051 1608 6 0 16.298718 -4.138023 18.121710 +6052 1608 4 0 15.424215 -3.680129 18.372722 +6053 1608 4 0 16.684549 -4.205202 19.001012 +6054 1609 6 0 -14.198508 -14.194772 -14.794207 +6055 1609 4 0 -13.444357 -14.590983 -14.343955 +6056 1609 4 0 -13.774495 -13.612371 -15.434882 +6057 1610 6 0 -10.030484 -15.925396 14.049869 +6058 1610 4 0 -9.661016 -16.753356 13.643301 +6059 1610 4 0 -9.506338 -15.169357 13.752939 +6060 1611 6 0 2.620657 -7.959507 -20.667278 +6061 1611 4 0 2.062110 -7.160386 -20.605865 +6062 1611 4 0 2.138798 -8.553220 -21.271787 +6063 1612 6 0 5.778060 4.436909 12.837835 +6064 1612 4 0 5.362329 3.721975 13.322111 +6065 1612 4 0 5.808629 5.246373 13.380366 +6066 1613 6 0 16.866472 5.920215 7.405820 +6067 1613 4 0 16.435352 5.086965 7.209575 +6068 1613 4 0 16.163833 6.543037 7.470100 +6069 1614 6 0 17.825944 -3.501642 -5.065436 +6070 1614 4 0 17.700510 -2.538825 -4.863235 +6071 1614 4 0 18.532466 -3.602326 -5.702852 +6072 1615 6 0 -11.681593 20.597292 5.432499 +6073 1615 4 0 -11.969564 21.510542 5.152859 +6074 1615 4 0 -12.562576 20.147115 5.430236 +6075 1616 6 0 21.531845 -18.609965 -11.465553 +6076 1616 4 0 21.036885 -18.970566 -10.752405 +6077 1616 4 0 20.911041 -18.252243 -12.167168 +6078 1617 6 0 0.249866 -13.875504 -5.737561 +6079 1617 4 0 1.053242 -14.152812 -5.334020 +6080 1617 4 0 0.540234 -13.078009 -6.238789 +6081 1618 6 0 3.047539 17.051565 11.568254 +6082 1618 4 0 3.164343 17.306128 12.474589 +6083 1618 4 0 2.524042 17.779795 11.213697 +6084 1619 6 0 24.178795 -4.873391 -17.954897 +6085 1619 4 0 23.609912 -4.083965 -18.078992 +6086 1619 4 0 24.401168 -4.923489 -16.992528 +6087 1620 6 0 3.954939 20.513379 -14.418517 +6088 1620 4 0 3.581046 20.093104 -15.154897 +6089 1620 4 0 3.811800 21.468596 -14.662255 +6090 1621 6 0 -0.149556 2.777227 -12.291758 +6091 1621 4 0 -0.121223 2.435369 -11.351012 +6092 1621 4 0 0.596183 3.441893 -12.318897 +6093 1622 6 0 27.193112 8.418341 -10.172198 +6094 1622 4 0 26.787164 8.259494 -11.042944 +6095 1622 4 0 27.410726 9.433106 -10.260356 +6096 1623 6 0 -24.022975 1.655208 -11.524687 +6097 1623 4 0 -24.291048 0.824835 -11.888466 +6098 1623 4 0 -24.881489 1.940641 -11.171341 +6099 1624 6 0 26.405280 -5.462847 -5.065504 +6100 1624 4 0 26.209462 -6.029181 -5.803215 +6101 1624 4 0 27.373218 -5.317034 -5.077630 +6102 1625 6 0 -3.690721 10.045789 -20.208648 +6103 1625 4 0 -4.248266 9.317998 -19.851069 +6104 1625 4 0 -2.834866 9.590938 -20.465215 +6105 1626 6 0 -2.559171 12.379195 -18.651596 +6106 1626 4 0 -3.295406 13.039384 -18.601178 +6107 1626 4 0 -2.957289 11.575659 -18.948915 +6108 1627 6 0 9.997514 -3.540058 20.611729 +6109 1627 4 0 9.428623 -3.673422 21.365363 +6110 1627 4 0 10.919581 -3.718379 20.892643 +6111 1628 6 0 22.711145 -8.644902 0.632604 +6112 1628 4 0 23.670226 -8.511619 0.628432 +6113 1628 4 0 22.493868 -9.498519 0.275412 +6114 1629 6 0 14.085903 -1.038370 -16.414394 +6115 1629 4 0 14.059869 -1.196217 -15.467296 +6116 1629 4 0 13.262318 -1.459953 -16.715075 +6117 1630 6 0 -12.216643 15.094727 14.953780 +6118 1630 4 0 -11.931679 15.769402 14.281719 +6119 1630 4 0 -13.149517 15.224147 15.123844 +6120 1631 6 0 -24.757277 7.231003 8.542276 +6121 1631 4 0 -24.784189 8.210199 8.450823 +6122 1631 4 0 -24.549551 6.922193 9.397707 +6123 1632 6 0 3.372929 19.847026 -0.606151 +6124 1632 4 0 3.191569 19.283633 -1.369340 +6125 1632 4 0 4.347642 20.010416 -0.683022 +6126 1633 6 0 8.872330 -16.761760 17.202410 +6127 1633 4 0 8.996558 -17.151460 16.293393 +6128 1633 4 0 9.700285 -17.024144 17.621618 +6129 1634 6 0 9.343569 14.953908 -19.877613 +6130 1634 4 0 9.005091 14.803515 -18.977870 +6131 1634 4 0 10.168474 14.477496 -19.931351 +6132 1635 6 0 2.034725 4.776928 20.854933 +6133 1635 4 0 2.700859 5.449702 20.919206 +6134 1635 4 0 1.289075 5.153942 21.314556 +6135 1636 6 0 18.285982 7.046313 3.854888 +6136 1636 4 0 18.754091 7.109170 3.047358 +6137 1636 4 0 18.852898 6.489134 4.447893 +6138 1637 6 0 17.000427 19.166068 19.844454 +6139 1637 4 0 17.780774 18.891038 19.347291 +6140 1637 4 0 16.338665 18.528198 19.533743 +6141 1638 6 0 4.309924 6.553220 -20.552969 +6142 1638 4 0 4.375422 6.917713 -21.455723 +6143 1638 4 0 5.249758 6.290930 -20.364274 +6144 1639 6 0 20.777753 -4.985339 -6.248152 +6145 1639 4 0 20.286399 -4.821264 -7.053768 +6146 1639 4 0 20.234568 -5.537952 -5.671124 +6147 1640 6 0 4.730675 15.020276 -10.674086 +6148 1640 4 0 4.376943 14.834207 -9.767214 +6149 1640 4 0 4.726770 15.973286 -10.733237 +6150 1641 6 0 2.355355 1.234033 17.572616 +6151 1641 4 0 3.034023 1.365267 16.849468 +6152 1641 4 0 1.929729 2.103871 17.645246 +6153 1642 6 0 -20.364763 -10.341423 19.798444 +6154 1642 4 0 -20.097141 -9.967826 18.943902 +6155 1642 4 0 -20.518570 -9.582890 20.375779 +6156 1643 6 0 24.191317 -20.301143 13.503559 +6157 1643 4 0 25.075667 -20.080336 13.914227 +6158 1643 4 0 23.551864 -19.853712 14.034970 +6159 1644 6 0 -17.771965 -0.812840 5.691659 +6160 1644 4 0 -17.110001 -0.172585 5.922995 +6161 1644 4 0 -18.609271 -0.533119 5.998788 +6162 1645 6 0 8.428411 7.992467 20.234546 +6163 1645 4 0 9.349683 8.062329 20.534745 +6164 1645 4 0 7.930578 8.665863 20.632958 +6165 1646 6 0 14.933965 18.875827 -5.159997 +6166 1646 4 0 14.094884 19.194527 -5.500018 +6167 1646 4 0 15.603425 19.608364 -5.196749 +6168 1647 6 0 -11.010909 -1.265131 18.652423 +6169 1647 4 0 -11.027649 -1.155636 17.705218 +6170 1647 4 0 -10.091875 -1.091225 18.938417 +6171 1648 6 0 -21.191413 -9.651017 -4.562795 +6172 1648 4 0 -20.962638 -9.680538 -5.508642 +6173 1648 4 0 -20.795476 -10.416878 -4.182448 +6174 1649 6 0 5.099725 -12.626597 -17.884817 +6175 1649 4 0 5.666927 -12.400935 -17.105607 +6176 1649 4 0 4.764175 -11.785457 -18.184293 +6177 1650 6 0 -21.388510 -5.492100 10.971049 +6178 1650 4 0 -22.216480 -5.626371 10.534286 +6179 1650 4 0 -21.551676 -5.367629 11.909886 +6180 1651 6 0 -26.689928 -8.293398 13.111418 +6181 1651 4 0 -27.003954 -8.182450 12.219010 +6182 1651 4 0 -26.900928 -9.235390 13.263182 +6183 1652 6 0 6.162303 19.062401 -17.622686 +6184 1652 4 0 5.955026 19.807434 -17.095725 +6185 1652 4 0 6.287880 18.311383 -17.062421 +6186 1653 6 0 -26.568944 19.936247 1.863051 +6187 1653 4 0 -26.429552 19.451776 1.050937 +6188 1653 4 0 -25.730651 20.069282 2.308590 +6189 1654 6 0 -12.939452 -17.938569 9.558916 +6190 1654 4 0 -12.598970 -18.093496 10.439491 +6191 1654 4 0 -13.201371 -18.755858 9.152488 +6192 1655 6 0 -11.464685 7.314998 -14.468616 +6193 1655 4 0 -12.254067 7.075040 -13.971198 +6194 1655 4 0 -11.784844 7.883355 -15.166065 +6195 1656 6 0 20.495565 -8.915532 9.256247 +6196 1656 4 0 19.761356 -9.177749 9.963841 +6197 1656 4 0 20.333767 -7.961456 9.244216 +6198 1657 6 0 -16.958223 -6.637117 15.942724 +6199 1657 4 0 -17.590511 -6.925764 15.256778 +6200 1657 4 0 -17.006530 -7.309307 16.639627 +6201 1658 6 0 -7.465242 20.880802 3.955458 +6202 1658 4 0 -6.906639 21.395406 3.368693 +6203 1658 4 0 -7.384772 21.435308 4.777200 +6204 1659 6 0 10.987484 -10.220761 -0.486092 +6205 1659 4 0 11.657995 -10.039232 -1.157052 +6206 1659 4 0 10.134305 -10.217278 -0.922065 +6207 1660 6 0 -11.745045 12.656305 2.561380 +6208 1660 4 0 -12.067404 12.975187 3.387647 +6209 1660 4 0 -11.009457 12.085090 2.865904 +6210 1661 6 0 -5.579572 -16.497607 -20.750701 +6211 1661 4 0 -4.847773 -16.621590 -21.371280 +6212 1661 4 0 -6.034567 -17.358476 -20.680344 +6213 1662 6 0 1.964841 -7.772342 -15.446535 +6214 1662 4 0 2.789953 -8.261174 -15.222416 +6215 1662 4 0 1.224980 -8.401255 -15.497885 +6216 1663 6 0 17.133687 20.836195 -5.235713 +6217 1663 4 0 16.963395 21.728366 -4.832203 +6218 1663 4 0 18.061664 20.710791 -5.306008 +6219 1664 6 0 -18.390780 10.973515 3.704388 +6220 1664 4 0 -19.253132 11.409402 3.769882 +6221 1664 4 0 -18.035350 10.771168 4.577357 +6222 1665 6 0 14.221292 20.673222 -19.936970 +6223 1665 4 0 13.920637 20.243897 -20.741067 +6224 1665 4 0 14.685112 21.462779 -20.332088 +6225 1666 6 0 -21.084831 12.253935 9.565359 +6226 1666 4 0 -20.600168 11.482007 9.886149 +6227 1666 4 0 -21.728096 12.542158 10.140605 +6228 1667 6 0 21.807475 -0.416214 2.152466 +6229 1667 4 0 22.039987 -0.306167 1.206900 +6230 1667 4 0 22.400722 -1.068057 2.516791 +6231 1668 6 0 20.924050 10.441338 14.208356 +6232 1668 4 0 21.615541 10.869208 14.797933 +6233 1668 4 0 20.771960 9.540413 14.573568 +6234 1669 6 0 6.259921 4.454937 -17.265429 +6235 1669 4 0 6.706330 4.203652 -18.064753 +6236 1669 4 0 5.711163 3.710753 -17.001578 +6237 1670 6 0 -4.214022 14.596706 -18.431597 +6238 1670 4 0 -3.688756 15.025866 -17.718188 +6239 1670 4 0 -5.088033 14.473133 -18.084790 +6240 1671 6 0 -2.199419 13.906578 9.672426 +6241 1671 4 0 -2.129396 13.038932 9.992785 +6242 1671 4 0 -3.120153 14.058476 9.477073 +6243 1672 6 0 9.044748 2.046702 -11.991573 +6244 1672 4 0 9.465655 2.820071 -11.709794 +6245 1672 4 0 8.080161 2.265383 -12.092250 +6246 1673 6 0 7.143894 -11.920235 -15.669336 +6247 1673 4 0 6.531119 -11.505986 -15.060545 +6248 1673 4 0 7.414267 -12.765754 -15.195832 +6249 1674 6 0 -5.826228 -0.168688 14.337506 +6250 1674 4 0 -5.465882 -0.527232 13.513436 +6251 1674 4 0 -5.608854 0.802946 14.323569 +6252 1675 6 0 5.648885 3.826675 19.190577 +6253 1675 4 0 5.186784 3.361795 19.925791 +6254 1675 4 0 5.056212 3.823989 18.450900 +6255 1676 6 0 9.326815 -6.082614 -17.012500 +6256 1676 4 0 10.201835 -6.094812 -17.433769 +6257 1676 4 0 9.461714 -5.493002 -16.251384 +6258 1677 6 0 -1.961522 -12.154184 11.549933 +6259 1677 4 0 -1.624684 -11.469274 10.968619 +6260 1677 4 0 -2.192863 -11.701664 12.378278 +6261 1678 6 0 22.610380 9.966271 5.674665 +6262 1678 4 0 23.383558 10.326639 6.158091 +6263 1678 4 0 22.639822 10.376867 4.833334 +6264 1679 6 0 -15.460748 19.613439 2.679694 +6265 1679 4 0 -16.411896 19.506793 2.586178 +6266 1679 4 0 -14.953260 19.393944 1.878689 +6267 1680 6 0 -9.915773 -6.329847 7.803991 +6268 1680 4 0 -9.882720 -5.651785 8.461110 +6269 1680 4 0 -10.460430 -6.991760 8.214687 +6270 1681 6 0 -25.207118 14.245870 9.965310 +6271 1681 4 0 -24.983683 14.155643 9.024696 +6272 1681 4 0 -26.142233 13.940881 10.004034 +6273 1682 6 0 -25.736790 -11.761067 -20.022820 +6274 1682 4 0 -25.863929 -11.074881 -20.678750 +6275 1682 4 0 -24.932339 -12.237137 -20.159436 +6276 1683 6 0 11.102836 18.814945 6.564463 +6277 1683 4 0 11.289797 19.730591 6.307298 +6278 1683 4 0 11.992226 18.441595 6.571960 +6279 1684 6 0 13.403000 -2.765436 13.474813 +6280 1684 4 0 13.769730 -2.059344 13.993878 +6281 1684 4 0 12.629241 -3.051764 13.938568 +6282 1685 6 0 -4.846771 12.989332 0.138872 +6283 1685 4 0 -5.140341 12.692091 -0.669471 +6284 1685 4 0 -4.237694 12.323085 0.503203 +6285 1686 6 0 -7.158804 -10.565376 -14.125410 +6286 1686 4 0 -7.106658 -9.969989 -13.387772 +6287 1686 4 0 -8.014522 -10.262139 -14.505555 +6288 1687 6 0 -27.281285 1.637807 7.500082 +6289 1687 4 0 -28.034365 1.595491 8.055974 +6290 1687 4 0 -27.473389 0.963037 6.821339 +6291 1688 6 0 -0.097834 20.799965 16.033059 +6292 1688 4 0 -0.061833 20.955427 16.971561 +6293 1688 4 0 0.211633 19.849506 15.947964 +6294 1689 6 0 -17.560941 -8.904350 -7.470152 +6295 1689 4 0 -17.692194 -9.827361 -7.296744 +6296 1689 4 0 -18.413628 -8.634527 -7.892701 +6297 1690 6 0 19.510410 -2.135779 6.750602 +6298 1690 4 0 19.129310 -2.691827 6.012246 +6299 1690 4 0 19.916248 -2.816246 7.354253 +6300 1691 6 0 -22.550074 2.726993 8.069055 +6301 1691 4 0 -22.055287 3.149406 8.816420 +6302 1691 4 0 -23.436863 2.498421 8.376578 +6303 1692 6 0 12.975725 16.091516 4.066177 +6304 1692 4 0 12.574447 15.652668 4.834328 +6305 1692 4 0 13.351330 15.347325 3.556206 +6306 1693 6 0 4.646769 -11.986650 5.429828 +6307 1693 4 0 4.999571 -11.714192 4.521067 +6308 1693 4 0 3.860805 -12.541717 5.180051 +6309 1694 6 0 -25.235875 -9.797804 -17.843826 +6310 1694 4 0 -24.333006 -9.678887 -17.478651 +6311 1694 4 0 -25.154219 -10.357082 -18.609102 +6312 1695 6 0 11.868872 -11.212949 -8.438903 +6313 1695 4 0 11.896093 -12.062241 -7.862109 +6314 1695 4 0 12.728803 -11.139741 -8.855401 +6315 1696 6 0 17.367617 -1.497743 -14.604934 +6316 1696 4 0 17.309530 -0.538237 -14.454327 +6317 1696 4 0 16.651273 -1.922704 -14.219436 +6318 1697 6 0 8.667339 4.899012 8.930629 +6319 1697 4 0 8.353473 5.408040 8.182722 +6320 1697 4 0 8.163336 5.229248 9.676915 +6321 1698 6 0 -15.429574 17.683315 9.572006 +6322 1698 4 0 -15.724205 17.604776 10.464011 +6323 1698 4 0 -15.265015 16.716829 9.310192 +6324 1699 6 0 -23.494483 -11.734522 -13.358407 +6325 1699 4 0 -22.637486 -11.515244 -13.732205 +6326 1699 4 0 -23.249990 -12.537148 -12.866248 +6327 1700 6 0 -2.321548 19.267216 -1.843679 +6328 1700 4 0 -1.979401 18.732155 -2.589027 +6329 1700 4 0 -1.922284 20.138548 -2.014462 +6330 1701 6 0 3.241639 7.816664 9.859978 +6331 1701 4 0 3.830186 8.534324 10.230363 +6332 1701 4 0 3.848530 7.292787 9.307399 +6333 1702 6 0 23.128975 -6.691964 -6.315464 +6334 1702 4 0 23.778438 -6.570891 -6.974137 +6335 1702 4 0 22.501465 -5.970161 -6.490266 +6336 1703 6 0 19.510034 14.065263 20.822119 +6337 1703 4 0 19.858660 14.498532 21.601080 +6338 1703 4 0 18.527411 14.085196 20.963708 +6339 1704 6 0 23.620502 15.862352 -17.889270 +6340 1704 4 0 23.702347 16.808368 -17.871251 +6341 1704 4 0 24.460420 15.474942 -18.227702 +6342 1705 6 0 0.280487 -11.413982 6.100970 +6343 1705 4 0 -0.020983 -11.734838 5.286550 +6344 1705 4 0 -0.533188 -11.093828 6.515383 +6345 1706 6 0 4.888182 13.212978 -12.788937 +6346 1706 4 0 4.811212 13.849406 -12.115682 +6347 1706 4 0 5.658749 13.451904 -13.292659 +6348 1707 6 0 -0.778683 -14.633842 19.192088 +6349 1707 4 0 0.068746 -14.541913 19.608269 +6350 1707 4 0 -0.746217 -14.102331 18.428497 +6351 1708 6 0 13.914707 -6.162346 9.195387 +6352 1708 4 0 13.649776 -6.881207 8.533412 +6353 1708 4 0 13.921705 -5.396594 8.630327 +6354 1709 6 0 5.918950 -10.003796 18.819888 +6355 1709 4 0 5.593681 -9.082358 18.773797 +6356 1709 4 0 6.335696 -10.082856 17.966116 +6357 1710 6 0 5.800793 -13.047074 9.485819 +6358 1710 4 0 5.149198 -12.578404 10.015587 +6359 1710 4 0 5.268076 -13.674415 8.965513 +6360 1711 6 0 -14.871416 6.062880 9.725201 +6361 1711 4 0 -14.929573 6.618371 8.917863 +6362 1711 4 0 -14.144906 5.419527 9.466087 +6363 1712 6 0 20.324875 13.466462 -0.499122 +6364 1712 4 0 21.247971 13.704707 -0.183814 +6365 1712 4 0 20.407782 13.624960 -1.484430 +6366 1713 6 0 14.435517 -20.166926 -14.557910 +6367 1713 4 0 15.392894 -20.186163 -14.367445 +6368 1713 4 0 14.408577 -20.346774 -15.497151 +6369 1714 6 0 -16.234833 1.803853 -11.857132 +6370 1714 4 0 -16.542525 1.963315 -10.988159 +6371 1714 4 0 -16.125965 2.663685 -12.253266 +6372 1715 6 0 5.603802 10.853652 14.181232 +6373 1715 4 0 4.967001 11.570744 14.103506 +6374 1715 4 0 5.112428 10.099067 14.600012 +6375 1716 6 0 -9.571538 -5.196535 -13.987191 +6376 1716 4 0 -8.921300 -5.201306 -13.287766 +6377 1716 4 0 -9.272779 -4.631556 -14.762861 +6378 1717 6 0 -0.910109 -6.872259 20.397408 +6379 1717 4 0 -1.142400 -7.798393 20.536047 +6380 1717 4 0 -1.036778 -6.702293 19.444051 +6381 1718 6 0 -12.922858 14.220990 -13.435094 +6382 1718 4 0 -13.045814 13.904342 -12.512925 +6383 1718 4 0 -11.991363 14.443415 -13.600018 +6384 1719 6 0 -20.145038 7.688023 -15.204652 +6385 1719 4 0 -19.285409 7.391425 -14.875634 +6386 1719 4 0 -20.496640 7.059764 -15.839841 +6387 1720 6 0 -5.329489 -11.195881 -18.058590 +6388 1720 4 0 -4.529646 -10.716556 -18.053482 +6389 1720 4 0 -5.175370 -11.944129 -17.502821 +6390 1721 6 0 -4.095176 7.801479 14.167088 +6391 1721 4 0 -4.165281 6.967753 13.710500 +6392 1721 4 0 -4.424466 8.518942 13.657209 +6393 1722 6 0 4.268934 -2.427400 -14.058821 +6394 1722 4 0 3.658313 -1.685938 -14.058738 +6395 1722 4 0 4.003282 -2.951965 -14.808726 +6396 1723 6 0 8.751768 -9.075907 8.222826 +6397 1723 4 0 8.238298 -9.781595 7.726938 +6398 1723 4 0 8.832788 -8.372787 7.566934 +6399 1724 6 0 -2.030633 -16.421805 9.382972 +6400 1724 4 0 -3.001825 -16.480774 9.651189 +6401 1724 4 0 -1.831960 -15.434055 9.498271 +6402 1725 6 0 -25.423917 -5.184358 19.460275 +6403 1725 4 0 -25.411355 -4.513854 18.790648 +6404 1725 4 0 -24.533549 -5.279059 19.872583 +6405 1726 6 0 -2.666399 -5.808727 -16.793146 +6406 1726 4 0 -2.024398 -6.172832 -16.200012 +6407 1726 4 0 -3.330516 -5.483909 -16.238573 +6408 1727 6 0 21.181989 15.710253 -10.722839 +6409 1727 4 0 20.653330 16.200547 -11.388544 +6410 1727 4 0 20.518018 15.224350 -10.216895 +6411 1728 6 0 10.656923 -19.476259 -2.456922 +6412 1728 4 0 10.832717 -19.488093 -3.445481 +6413 1728 4 0 10.250558 -20.351142 -2.291869 +6414 1729 6 0 25.111320 11.672906 -19.193595 +6415 1729 4 0 25.138171 11.478665 -18.282125 +6416 1729 4 0 24.182357 11.511761 -19.351363 +6417 1730 6 0 -23.200367 10.470264 2.902172 +6418 1730 4 0 -22.375402 10.749923 3.283481 +6419 1730 4 0 -23.150590 10.446395 1.924180 +6420 1731 6 0 -2.505105 -5.473938 -19.743686 +6421 1731 4 0 -1.843966 -5.849443 -20.362634 +6422 1731 4 0 -2.920619 -6.270770 -19.289080 +6423 1732 6 0 -8.780745 -1.877077 -14.922296 +6424 1732 4 0 -8.514938 -2.635843 -15.397360 +6425 1732 4 0 -9.085199 -1.200825 -15.532893 +6426 1733 6 0 24.088505 -5.188189 -2.808937 +6427 1733 4 0 23.599921 -6.002172 -2.943267 +6428 1733 4 0 23.455922 -4.686553 -2.320873 +6429 1734 6 0 22.351359 7.425470 -10.093129 +6430 1734 4 0 22.221254 8.332765 -9.845260 +6431 1734 4 0 21.646534 6.920728 -9.570168 +6432 1735 6 0 14.350169 18.359669 4.097284 +6433 1735 4 0 14.109937 17.421914 3.931070 +6434 1735 4 0 14.072554 18.536427 5.036536 +6435 1736 6 0 27.317468 -3.450042 0.124188 +6436 1736 4 0 26.939527 -2.629423 0.463932 +6437 1736 4 0 28.260772 -3.496973 0.454380 +6438 1737 6 0 18.669483 0.162292 12.223874 +6439 1737 4 0 17.730334 0.262878 12.571330 +6440 1737 4 0 18.943346 -0.589794 12.749858 +6441 1738 6 0 -5.566955 -16.930775 -16.571789 +6442 1738 4 0 -6.441648 -17.209772 -16.309110 +6443 1738 4 0 -5.639154 -16.106816 -17.074766 +6444 1739 6 0 -2.921475 20.285760 15.744633 +6445 1739 4 0 -2.016920 20.514916 15.782961 +6446 1739 4 0 -3.245126 20.259651 16.667577 +6447 1740 6 0 -5.332369 15.647169 -3.415792 +6448 1740 4 0 -5.780073 16.016536 -4.186943 +6449 1740 4 0 -5.479798 16.195769 -2.646722 +6450 1741 6 0 15.921074 -18.186514 13.419302 +6451 1741 4 0 16.506049 -18.207521 14.214727 +6452 1741 4 0 15.521744 -17.337545 13.281325 +6453 1742 6 0 14.356618 -12.746498 14.307435 +6454 1742 4 0 14.126271 -12.290732 13.456316 +6455 1742 4 0 14.125424 -12.072615 14.973510 +6456 1743 6 0 -24.563586 19.861169 16.888289 +6457 1743 4 0 -24.271423 19.518156 17.745286 +6458 1743 4 0 -25.132062 20.568890 17.055680 +6459 1744 6 0 21.313706 -20.874831 -18.789259 +6460 1744 4 0 22.217533 -20.760960 -18.415032 +6461 1744 4 0 20.727813 -20.829114 -18.018243 +6462 1745 6 0 -22.635680 0.425745 -16.655779 +6463 1745 4 0 -22.761860 0.339162 -17.612196 +6464 1745 4 0 -23.459506 0.792307 -16.373813 +6465 1746 6 0 26.144043 -9.495490 -14.387597 +6466 1746 4 0 25.579221 -8.746398 -14.601070 +6467 1746 4 0 25.873666 -10.165392 -15.002042 +6468 1747 6 0 -23.297595 -18.906211 -0.461159 +6469 1747 4 0 -22.408325 -19.188074 -0.167323 +6470 1747 4 0 -23.911286 -19.189688 0.234806 +6471 1748 6 0 -0.622548 17.838288 10.712907 +6472 1748 4 0 -1.439971 18.247686 10.442799 +6473 1748 4 0 -0.378140 17.187351 10.096413 +6474 1749 6 0 15.411072 -13.353252 8.623995 +6475 1749 4 0 14.707363 -12.901715 8.076042 +6476 1749 4 0 15.905287 -13.988830 8.076423 +6477 1750 6 0 21.923001 -19.583331 -14.240322 +6478 1750 4 0 22.075731 -18.649005 -14.150919 +6479 1750 4 0 22.015325 -19.897017 -13.337089 +6480 1751 6 0 2.935997 17.036657 8.133011 +6481 1751 4 0 3.807044 17.141662 7.698882 +6482 1751 4 0 2.908723 17.824640 8.654298 +6483 1752 6 0 -27.412013 18.278336 3.981062 +6484 1752 4 0 -28.006219 18.986550 3.874615 +6485 1752 4 0 -26.604657 18.625220 3.564949 +6486 1753 6 0 24.767119 -17.376689 8.467100 +6487 1753 4 0 25.034677 -18.274073 8.247745 +6488 1753 4 0 24.572504 -17.372764 9.407309 +6489 1754 6 0 -13.003243 -11.441578 13.780080 +6490 1754 4 0 -12.042782 -11.458495 13.652747 +6491 1754 4 0 -13.148063 -12.394708 13.704955 +6492 1755 6 0 15.688282 -7.232516 -0.339939 +6493 1755 4 0 16.449877 -6.627843 -0.361901 +6494 1755 4 0 14.991365 -6.661690 -0.041038 +6495 1756 6 0 11.147257 19.763552 -1.319428 +6496 1756 4 0 12.091516 19.826512 -1.542128 +6497 1756 4 0 10.791166 18.908813 -1.667004 +6498 1757 6 0 -7.494481 -7.378915 14.293630 +6499 1757 4 0 -8.055772 -6.598314 14.231678 +6500 1757 4 0 -7.492239 -7.996336 13.497808 +6501 1758 6 0 12.398150 -14.923360 -13.423871 +6502 1758 4 0 13.226011 -15.063936 -12.905542 +6503 1758 4 0 12.384263 -15.811229 -13.930308 +6504 1759 6 0 -27.354781 16.207013 -2.080282 +6505 1759 4 0 -27.773374 15.417476 -1.753252 +6506 1759 4 0 -26.769089 15.853853 -2.726016 +6507 1760 6 0 -21.588756 -10.691290 -14.634202 +6508 1760 4 0 -20.864974 -10.142417 -14.313329 +6509 1760 4 0 -22.092217 -10.206931 -15.343402 +6510 1761 6 0 -15.891662 -2.331448 -9.986612 +6511 1761 4 0 -16.165526 -2.271915 -10.920230 +6512 1761 4 0 -16.438270 -1.699757 -9.489314 +6513 1762 6 0 22.887456 16.566156 19.955577 +6514 1762 4 0 23.271415 15.746747 20.347130 +6515 1762 4 0 22.072508 16.181382 19.562781 +6516 1763 6 0 23.972546 -20.036642 10.589623 +6517 1763 4 0 22.980691 -20.033626 10.504814 +6518 1763 4 0 24.188289 -20.743981 11.184377 +6519 1764 6 0 -14.810897 -16.471565 2.793852 +6520 1764 4 0 -14.868506 -16.959673 3.603780 +6521 1764 4 0 -15.147942 -15.567810 2.891865 +6522 1765 6 0 15.022183 19.763656 9.414504 +6523 1765 4 0 14.727721 20.725814 9.294400 +6524 1765 4 0 14.198126 19.316744 9.803487 +6525 1766 6 0 7.167340 -17.033861 0.122492 +6526 1766 4 0 7.922624 -17.174527 -0.428152 +6527 1766 4 0 7.373246 -16.583291 0.937782 +6528 1767 6 0 -11.594968 10.896089 -10.580500 +6529 1767 4 0 -11.121081 11.033261 -11.432170 +6530 1767 4 0 -10.865005 11.002637 -9.903313 +6531 1768 6 0 13.844708 19.069913 -14.047834 +6532 1768 4 0 12.983337 18.716343 -13.811534 +6533 1768 4 0 13.787413 20.053839 -14.066463 +6534 1769 6 0 3.487281 19.589235 9.612730 +6535 1769 4 0 2.698355 20.090461 9.969632 +6536 1769 4 0 4.250101 19.910242 10.053781 +6537 1770 6 0 -3.973097 19.421213 7.719503 +6538 1770 4 0 -4.241991 20.257528 7.213642 +6539 1770 4 0 -3.132076 19.220373 7.212628 +6540 1771 6 0 -12.775076 2.609100 10.411237 +6541 1771 4 0 -11.827718 2.459042 10.644395 +6542 1771 4 0 -12.804655 2.331119 9.464699 +6543 1772 6 0 -24.197168 6.439006 -6.711367 +6544 1772 4 0 -25.160507 6.393035 -6.538446 +6545 1772 4 0 -23.942233 5.506445 -6.828627 +6546 1773 6 0 -2.117774 -4.949968 18.594717 +6547 1773 4 0 -2.924336 -5.465197 18.506055 +6548 1773 4 0 -2.296534 -4.057750 18.222583 +6549 1774 6 0 -10.788206 6.295992 1.048829 +6550 1774 4 0 -10.485607 7.066710 1.589289 +6551 1774 4 0 -10.038032 6.105261 0.487985 +6552 1775 6 0 -12.857377 -3.305264 -10.725085 +6553 1775 4 0 -13.206640 -2.923560 -11.499351 +6554 1775 4 0 -13.499606 -3.077602 -10.047332 +6555 1776 6 0 -11.268130 12.801261 9.055194 +6556 1776 4 0 -11.672865 13.689974 8.877182 +6557 1776 4 0 -11.032167 12.415049 8.150138 +6558 1777 6 0 13.406197 0.438838 6.515611 +6559 1777 4 0 12.971912 1.148987 7.055731 +6560 1777 4 0 13.378188 0.782754 5.596959 +6561 1778 6 0 16.121687 13.290724 10.280494 +6562 1778 4 0 16.894647 12.756757 10.507582 +6563 1778 4 0 15.529920 12.609242 9.885455 +6564 1779 6 0 1.591126 8.482167 4.697447 +6565 1779 4 0 1.970540 9.119397 4.113006 +6566 1779 4 0 2.267655 8.435325 5.388951 +6567 1780 6 0 -17.696505 1.721021 10.517174 +6568 1780 4 0 -17.885845 2.645526 10.594973 +6569 1780 4 0 -18.179500 1.418546 11.298333 +6570 1781 6 0 -1.148874 9.889607 17.693251 +6571 1781 4 0 -0.454725 10.039896 17.084647 +6572 1781 4 0 -1.617929 9.083378 17.328962 +6573 1782 6 0 -9.511269 -11.292655 15.803762 +6574 1782 4 0 -10.218255 -10.722353 16.196307 +6575 1782 4 0 -9.799298 -12.212118 15.932439 +6576 1783 6 0 -15.065889 16.639418 -8.067448 +6577 1783 4 0 -15.835102 17.201609 -8.362394 +6578 1783 4 0 -15.172025 15.753046 -8.516586 +6579 1784 6 0 -22.136814 -17.146244 -13.973167 +6580 1784 4 0 -21.367059 -16.850746 -13.432779 +6581 1784 4 0 -22.384487 -16.427789 -14.634859 +6582 1785 6 0 7.866282 -10.293632 -17.800934 +6583 1785 4 0 7.775951 -11.047150 -17.161148 +6584 1785 4 0 8.173086 -9.555520 -17.163954 +6585 1786 6 0 -11.457596 -0.574420 15.816493 +6586 1786 4 0 -11.795621 0.320073 15.789591 +6587 1786 4 0 -10.561019 -0.510839 15.442995 +6588 1787 6 0 20.020980 -12.359468 -8.719780 +6589 1787 4 0 20.891102 -12.503083 -8.310836 +6590 1787 4 0 19.657638 -11.746384 -8.095286 +6591 1788 6 0 -11.584374 -20.453145 18.626549 +6592 1788 4 0 -11.940173 -20.540398 19.531255 +6593 1788 4 0 -12.005638 -21.078955 18.029825 +6594 1789 6 0 3.431174 19.121516 18.407979 +6595 1789 4 0 3.226206 20.056373 18.426687 +6596 1789 4 0 2.600881 18.679871 18.370259 +6597 1790 6 0 -13.315767 -3.798762 16.329856 +6598 1790 4 0 -13.096103 -4.569637 15.670760 +6599 1790 4 0 -12.649730 -3.801668 17.013121 +6600 1791 6 0 7.563392 -5.518546 10.504795 +6601 1791 4 0 6.706770 -5.750354 10.096728 +6602 1791 4 0 7.922512 -6.417021 10.555834 +6603 1792 6 0 -18.725820 19.110329 -7.091283 +6604 1792 4 0 -19.518142 19.318716 -7.662306 +6605 1792 4 0 -18.568680 19.881279 -6.590714 +6606 1793 6 0 -1.414023 -16.961715 12.639857 +6607 1793 4 0 -1.328118 -15.968577 12.668980 +6608 1793 4 0 -1.076983 -17.347672 11.778245 +6609 1794 6 0 -23.307644 10.461811 -20.820802 +6610 1794 4 0 -23.561946 9.673912 -20.318452 +6611 1794 4 0 -24.099105 10.583838 -21.379713 +6612 1795 6 0 18.109258 -13.123924 17.182346 +6613 1795 4 0 19.074027 -13.199454 16.973877 +6614 1795 4 0 17.765173 -12.302968 16.728002 +6615 1796 6 0 21.683386 18.223931 -5.030005 +6616 1796 4 0 22.567099 18.027021 -5.437892 +6617 1796 4 0 21.636745 17.754335 -4.163593 +6618 1797 6 0 25.055072 19.034839 -7.681292 +6619 1797 4 0 24.766294 18.344263 -7.038060 +6620 1797 4 0 25.882695 18.757787 -7.948244 +6621 1798 6 0 15.570913 13.019010 5.553904 +6622 1798 4 0 15.992685 13.329314 6.362922 +6623 1798 4 0 15.449140 12.068146 5.738277 +6624 1799 6 0 -0.520016 -0.269780 14.795928 +6625 1799 4 0 -0.180326 -0.456884 15.694661 +6626 1799 4 0 -1.219092 -0.915185 14.727056 +6627 1800 6 0 1.663902 -15.429144 -10.527250 +6628 1800 4 0 2.554915 -15.533567 -10.136462 +6629 1800 4 0 1.815948 -15.297258 -11.416174 +6630 1801 6 0 -22.648336 -4.623238 -12.225694 +6631 1801 4 0 -23.412412 -4.010770 -12.025660 +6632 1801 4 0 -21.872894 -4.224451 -11.815463 +6633 1802 6 0 -2.279585 -20.867759 -19.023308 +6634 1802 4 0 -3.100549 -20.369345 -19.314139 +6635 1802 4 0 -1.811469 -21.235753 -19.767859 +6636 1803 6 0 -22.243475 -13.329179 -1.390694 +6637 1803 4 0 -22.862810 -12.659332 -1.686427 +6638 1803 4 0 -22.410657 -13.599367 -0.469217 +6639 1804 6 0 23.607826 -9.844602 16.352810 +6640 1804 4 0 24.370141 -9.837102 16.979270 +6641 1804 4 0 22.885616 -9.527980 16.925581 +6642 1805 6 0 -17.460421 9.171816 -11.938616 +6643 1805 4 0 -18.218389 8.865436 -11.398928 +6644 1805 4 0 -17.867876 9.968898 -12.335632 +6645 1806 6 0 2.263863 -17.526491 14.554618 +6646 1806 4 0 1.859635 -17.896680 15.358713 +6647 1806 4 0 2.052535 -18.087323 13.764230 +6648 1807 6 0 27.368617 -13.116454 -17.139830 +6649 1807 4 0 27.233784 -13.465846 -16.264251 +6650 1807 4 0 27.362385 -13.865254 -17.806940 +6651 1808 6 0 16.784972 2.549591 14.309398 +6652 1808 4 0 17.733190 2.537919 14.322805 +6653 1808 4 0 16.413277 1.810095 13.861707 +6654 1809 6 0 21.804761 -2.107242 -5.095741 +6655 1809 4 0 22.776789 -2.281899 -4.959560 +6656 1809 4 0 21.413198 -2.898127 -5.388708 +6657 1810 6 0 14.063924 6.483674 -0.351431 +6658 1810 4 0 14.941176 6.100507 -0.517796 +6659 1810 4 0 14.071859 7.050391 0.399753 +6660 1811 6 0 14.554835 16.507491 9.329558 +6661 1811 4 0 15.358643 16.591416 9.875030 +6662 1811 4 0 13.889851 17.088326 9.657109 +6663 1812 6 0 8.670655 -18.428515 -11.354395 +6664 1812 4 0 9.496711 -18.254251 -11.776580 +6665 1812 4 0 8.693110 -18.508570 -10.379319 +6666 1813 6 0 -17.333287 2.077059 19.999340 +6667 1813 4 0 -18.012974 2.265838 19.359237 +6668 1813 4 0 -17.678958 2.658724 20.686523 +6669 1814 6 0 -12.269943 7.557325 8.022561 +6670 1814 4 0 -11.782231 7.901385 7.310410 +6671 1814 4 0 -11.518722 7.369844 8.741429 +6672 1815 6 0 -16.422160 -12.244301 6.857276 +6673 1815 4 0 -16.476236 -12.690789 7.708566 +6674 1815 4 0 -17.265810 -12.438972 6.474023 +6675 1816 6 0 -12.460293 15.701651 -2.123616 +6676 1816 4 0 -12.202263 16.633440 -2.262429 +6677 1816 4 0 -12.915395 15.335750 -2.913659 +6678 1817 6 0 19.857137 7.435921 -19.855513 +6679 1817 4 0 19.224411 8.121790 -20.149860 +6680 1817 4 0 19.459580 7.115365 -18.985221 +6681 1818 6 0 27.414938 3.220691 12.551587 +6682 1818 4 0 28.302084 3.292286 12.082110 +6683 1818 4 0 27.376652 2.288121 12.758098 +6684 1819 6 0 -20.578446 6.501862 -7.543872 +6685 1819 4 0 -21.322455 7.133983 -7.483478 +6686 1819 4 0 -20.905164 5.709027 -7.068017 +6687 1820 6 0 9.893421 -13.954239 -2.145744 +6688 1820 4 0 10.845577 -13.887452 -1.806008 +6689 1820 4 0 9.670044 -13.100245 -2.522670 +6690 1821 6 0 -4.428072 -19.794959 6.392084 +6691 1821 4 0 -3.499634 -19.499125 6.457248 +6692 1821 4 0 -4.796122 -19.302160 7.159538 +6693 1822 6 0 -7.874919 11.488098 -11.872687 +6694 1822 4 0 -7.741906 10.850602 -11.130468 +6695 1822 4 0 -8.663122 11.156415 -12.262641 +6696 1823 6 0 25.941607 -13.435898 9.799183 +6697 1823 4 0 26.834803 -13.623931 10.154795 +6698 1823 4 0 25.332757 -14.073159 10.291155 +6699 1824 6 0 -19.551589 -5.315854 19.441555 +6700 1824 4 0 -19.573638 -5.247652 20.432003 +6701 1824 4 0 -18.874142 -4.641904 19.223175 +6702 1825 6 0 -15.895156 17.865430 12.295752 +6703 1825 4 0 -15.942604 18.800693 12.596548 +6704 1825 4 0 -16.548061 17.362585 12.771509 +6705 1826 6 0 2.671083 -14.766415 2.401009 +6706 1826 4 0 1.987603 -14.345575 1.847880 +6707 1826 4 0 2.531547 -14.517967 3.328895 +6708 1827 6 0 12.335851 -9.704468 -20.394740 +6709 1827 4 0 12.648806 -9.830295 -19.492670 +6710 1827 4 0 11.490958 -10.100623 -20.194535 +6711 1828 6 0 -22.106737 -9.538400 8.455985 +6712 1828 4 0 -21.536209 -9.084366 9.058590 +6713 1828 4 0 -23.017732 -9.207212 8.501551 +6714 1829 6 0 12.648535 6.444583 -9.932281 +6715 1829 4 0 13.157813 6.358331 -10.726454 +6716 1829 4 0 11.747411 6.253342 -10.180418 +6717 1830 6 0 -13.625525 -14.166725 14.041460 +6718 1830 4 0 -13.177614 -14.592522 13.259629 +6719 1830 4 0 -14.592492 -14.334369 13.940732 +6720 1831 6 0 6.601614 16.498956 -16.461129 +6721 1831 4 0 7.358480 15.895066 -16.451685 +6722 1831 4 0 6.023786 16.041896 -17.084703 +6723 1832 6 0 21.778571 -2.612574 13.360688 +6724 1832 4 0 22.384822 -2.519802 12.682789 +6725 1832 4 0 21.622799 -1.672884 13.624001 +6726 1833 6 0 -20.149213 6.013192 6.945622 +6727 1833 4 0 -21.145473 5.909263 6.918876 +6728 1833 4 0 -19.835482 6.282517 6.065703 +6729 1834 6 0 -21.966774 -11.494919 -8.738743 +6730 1834 4 0 -22.851768 -11.211695 -9.113733 +6731 1834 4 0 -21.879165 -10.921961 -8.012191 +6732 1835 6 0 15.449095 -9.497086 12.201305 +6733 1835 4 0 16.382306 -9.836986 12.244632 +6734 1835 4 0 15.422419 -9.084200 11.356115 +6735 1836 6 0 12.664756 -15.306651 -20.531836 +6736 1836 4 0 12.034408 -16.012414 -20.359938 +6737 1836 4 0 12.739209 -14.577278 -19.974973 +6738 1837 6 0 -7.972869 -5.604918 -11.934405 +6739 1837 4 0 -7.601267 -4.885318 -11.379446 +6740 1837 4 0 -8.575310 -6.063681 -11.263704 +6741 1838 6 0 0.299553 12.700530 -18.524181 +6742 1838 4 0 0.558430 11.815355 -18.777046 +6743 1838 4 0 -0.711668 12.618485 -18.481012 +6744 1839 6 0 -0.824908 18.918494 -20.332651 +6745 1839 4 0 0.055729 18.800950 -20.088514 +6746 1839 4 0 -0.726815 18.736133 -21.275575 +6747 1840 6 0 25.716218 -17.621624 -18.165089 +6748 1840 4 0 25.183585 -18.348327 -18.615572 +6749 1840 4 0 26.570805 -18.051277 -17.821631 +6750 1841 6 0 11.895246 -12.886376 -15.030415 +6751 1841 4 0 12.581969 -12.241572 -14.789572 +6752 1841 4 0 12.014494 -13.590976 -14.363464 +6753 1842 6 0 -6.984781 -6.050242 10.699580 +6754 1842 4 0 -6.200372 -6.230567 10.144341 +6755 1842 4 0 -6.715278 -5.563587 11.454374 +6756 1843 6 0 -7.335609 -12.055455 -4.954546 +6757 1843 4 0 -6.870389 -12.537029 -5.731051 +6758 1843 4 0 -8.034369 -11.614893 -5.410536 +6759 1844 6 0 7.328653 12.351276 10.622525 +6760 1844 4 0 7.205722 12.826673 9.764783 +6761 1844 4 0 6.491360 12.585679 11.094427 +6762 1845 6 0 -2.064418 15.964062 4.897369 +6763 1845 4 0 -1.989044 16.110456 3.944429 +6764 1845 4 0 -1.188158 16.010465 5.256453 +6765 1846 6 0 10.673140 16.947190 -7.298199 +6766 1846 4 0 11.053321 16.848368 -6.437645 +6767 1846 4 0 9.833705 16.415071 -7.530378 +6768 1847 6 0 25.146955 -10.850377 -5.894794 +6769 1847 4 0 25.793466 -10.144367 -5.792885 +6770 1847 4 0 25.341761 -11.315139 -6.748470 +6771 1848 6 0 -20.898709 -20.024244 -0.432532 +6772 1848 4 0 -21.327485 -20.809324 -0.731327 +6773 1848 4 0 -20.384646 -19.736744 -1.159428 +6774 1849 6 0 15.773125 -11.828239 1.267979 +6775 1849 4 0 15.082308 -11.485912 1.791000 +6776 1849 4 0 16.210809 -11.047975 0.843250 +6777 1850 6 0 -25.459831 -14.049130 16.602221 +6778 1850 4 0 -25.659268 -15.033606 16.753032 +6779 1850 4 0 -26.167299 -13.609133 17.155971 +6780 1851 6 0 -15.346212 9.776118 0.552706 +6781 1851 4 0 -14.861031 10.583944 0.897097 +6782 1851 4 0 -15.499398 9.230659 1.360288 +6783 1852 6 0 1.515239 -10.027493 16.408903 +6784 1852 4 0 2.112245 -9.685145 15.772127 +6785 1852 4 0 1.563862 -10.961534 16.268707 +6786 1853 6 0 8.730778 -2.046469 -16.855487 +6787 1853 4 0 8.003213 -2.349766 -16.293070 +6788 1853 4 0 8.893912 -1.127143 -16.700440 +6789 1854 6 0 -12.659858 10.277753 9.764551 +6790 1854 4 0 -12.954976 10.194740 10.671493 +6791 1854 4 0 -12.294313 11.185370 9.686563 +6792 1855 6 0 13.241019 7.614156 1.958471 +6793 1855 4 0 13.989186 7.821908 2.548064 +6794 1855 4 0 12.569506 7.225025 2.564990 +6795 1856 6 0 18.743445 -1.851686 14.221199 +6796 1856 4 0 19.241705 -2.155912 15.013052 +6797 1856 4 0 17.934973 -2.360999 14.283218 +6798 1857 6 0 20.097738 14.045420 -3.353931 +6799 1857 4 0 20.264111 13.632005 -4.240012 +6800 1857 4 0 19.782670 14.876950 -3.580329 +6801 1858 6 0 22.656523 -13.025771 -7.851202 +6802 1858 4 0 23.058494 -13.682024 -8.427211 +6803 1858 4 0 22.939496 -13.206983 -6.927788 +6804 1859 6 0 22.687429 4.701978 5.232797 +6805 1859 4 0 22.127391 3.970799 5.568822 +6806 1859 4 0 22.543397 5.316387 5.948219 +6807 1860 6 0 23.649228 -7.915795 -3.510236 +6808 1860 4 0 22.801078 -8.238516 -3.339971 +6809 1860 4 0 23.474938 -7.503073 -4.391727 +6810 1861 6 0 -6.616017 -20.555130 17.274390 +6811 1861 4 0 -6.785872 -19.593361 17.044755 +6812 1861 4 0 -6.639098 -20.935653 16.386762 +6813 1862 6 0 11.575769 10.993842 8.632733 +6814 1862 4 0 11.631285 10.248287 9.251562 +6815 1862 4 0 11.054687 11.776369 9.032913 +6816 1863 6 0 -14.897591 -13.741408 -8.424343 +6817 1863 4 0 -13.944044 -13.521919 -8.374624 +6818 1863 4 0 -15.245652 -13.416716 -9.247098 +6819 1864 6 0 -7.606286 -16.239672 5.296165 +6820 1864 4 0 -8.529013 -16.377754 5.125689 +6821 1864 4 0 -7.372109 -15.298609 5.089587 +6822 1865 6 0 21.651688 -6.687757 -17.914010 +6823 1865 4 0 21.631109 -7.371723 -17.250699 +6824 1865 4 0 22.595382 -6.421930 -17.913376 +6825 1866 6 0 8.244086 -0.418132 8.413538 +6826 1866 4 0 8.150004 -1.042562 7.678730 +6827 1866 4 0 7.835426 -0.797019 9.189825 +6828 1867 6 0 16.479760 -10.801798 -19.696932 +6829 1867 4 0 17.075192 -11.093875 -20.402321 +6830 1867 4 0 17.056365 -10.719762 -18.940382 +6831 1868 6 0 -0.277774 0.459271 -13.592265 +6832 1868 4 0 0.641958 0.154550 -13.512461 +6833 1868 4 0 -0.452113 1.346343 -13.286369 +6834 1869 6 0 -6.542284 15.376168 4.177517 +6835 1869 4 0 -5.816160 15.112821 4.810192 +6836 1869 4 0 -6.899831 14.592226 3.628797 +6837 1870 6 0 -20.635866 7.001713 -1.480479 +6838 1870 4 0 -21.373222 6.994284 -2.078088 +6839 1870 4 0 -20.006067 6.359671 -1.951231 +6840 1871 6 0 -13.639335 3.376760 17.002766 +6841 1871 4 0 -13.969979 2.665180 17.593575 +6842 1871 4 0 -13.046017 3.905659 17.530455 +6843 1872 6 0 -6.547337 20.684985 14.541933 +6844 1872 4 0 -6.972273 21.348698 14.071679 +6845 1872 4 0 -5.602331 20.918763 14.522709 +6846 1873 6 0 -2.497800 -13.782262 -4.791828 +6847 1873 4 0 -1.576617 -13.507624 -4.869174 +6848 1873 4 0 -2.714797 -14.013702 -5.709334 +6849 1874 6 0 -1.112625 18.563757 18.790030 +6850 1874 4 0 -0.288236 18.142534 18.527379 +6851 1874 4 0 -0.946536 19.452779 18.744542 +6852 1875 6 0 -13.988854 -2.769276 -13.122084 +6853 1875 4 0 -13.598926 -2.700606 -13.943868 +6854 1875 4 0 -14.937873 -2.607884 -13.208114 +6855 1876 6 0 -16.715661 8.750744 -17.681497 +6856 1876 4 0 -15.798116 8.603619 -18.047851 +6857 1876 4 0 -16.635460 9.420085 -17.000771 +6858 1877 6 0 2.991113 -12.748536 9.631899 +6859 1877 4 0 2.533802 -13.278079 8.996870 +6860 1877 4 0 2.583180 -11.923543 9.637997 +6861 1878 6 0 -27.414426 -12.634511 18.337817 +6862 1878 4 0 -28.225666 -12.744824 17.838871 +6863 1878 4 0 -27.706128 -12.906300 19.286418 +6864 1879 6 0 11.850131 -20.736745 10.117226 +6865 1879 4 0 12.209918 -19.885422 9.990598 +6866 1879 4 0 12.449458 -21.164159 10.776006 +6867 1880 6 0 16.900404 -9.611117 0.299881 +6868 1880 4 0 17.702920 -9.200486 0.626455 +6869 1880 4 0 16.211832 -8.949525 0.285394 +6870 1881 6 0 1.300636 17.476583 -19.357702 +6871 1881 4 0 1.244601 16.535623 -19.680589 +6872 1881 4 0 2.229065 17.802299 -19.528512 +6873 1882 6 0 -13.442641 6.855380 -12.602329 +6874 1882 4 0 -13.248683 5.960155 -12.345808 +6875 1882 4 0 -12.964930 7.379163 -11.927446 +6876 1883 6 0 10.508692 10.781998 13.857653 +6877 1883 4 0 10.700750 11.227397 13.025331 +6878 1883 4 0 11.274159 10.169036 14.047871 +6879 1884 6 0 -15.161111 15.497808 -1.075417 +6880 1884 4 0 -14.941306 16.067302 -1.834212 +6881 1884 4 0 -14.307102 15.425376 -0.587763 +6882 1885 6 0 26.516448 19.605204 -1.401155 +6883 1885 4 0 27.409955 19.971686 -1.420282 +6884 1885 4 0 26.420947 18.971191 -0.667802 +6885 1886 6 0 -0.954004 8.187819 13.771505 +6886 1886 4 0 -0.458409 7.469182 14.137804 +6887 1886 4 0 -1.797548 7.882182 13.530929 +6888 1887 6 0 15.694940 -16.566561 10.671838 +6889 1887 4 0 15.180482 -16.576742 9.844033 +6890 1887 4 0 14.966563 -16.548505 11.318780 +6891 1888 6 0 18.598747 3.441754 -19.980603 +6892 1888 4 0 19.607131 3.445422 -19.714075 +6893 1888 4 0 18.629619 3.587760 -20.937873 +6894 1889 6 0 -4.101725 20.626483 18.518698 +6895 1889 4 0 -4.832741 21.173287 18.195756 +6896 1889 4 0 -3.506641 21.284151 19.004490 +6897 1890 6 0 -1.622747 20.903759 -10.623135 +6898 1890 4 0 -1.749055 20.907257 -9.665824 +6899 1890 4 0 -2.518273 20.806241 -11.004696 +6900 1891 6 0 -2.179807 -14.291095 -12.926864 +6901 1891 4 0 -2.705153 -14.473812 -12.111290 +6902 1891 4 0 -1.495280 -13.773858 -12.562680 +6903 1892 6 0 -21.678830 15.695505 11.326422 +6904 1892 4 0 -21.490132 16.123832 12.219822 +6905 1892 4 0 -22.555374 16.000330 11.105890 +6906 1893 6 0 20.387528 -15.104299 -14.428654 +6907 1893 4 0 19.639614 -14.550582 -14.652181 +6908 1893 4 0 20.966724 -14.615439 -13.782083 +6909 1894 6 0 8.543989 2.061633 14.171285 +6910 1894 4 0 8.138366 1.205164 14.195988 +6911 1894 4 0 8.018048 2.600851 14.790181 +6912 1895 6 0 -14.889828 7.565748 -1.232224 +6913 1895 4 0 -15.277980 8.149588 -0.532147 +6914 1895 4 0 -14.157076 7.163538 -0.720742 +6915 1896 6 0 6.890439 6.835565 10.786892 +6916 1896 4 0 7.316224 7.702174 10.597929 +6917 1896 4 0 7.041785 6.699181 11.734956 +6918 1897 6 0 -23.725715 6.589830 20.135978 +6919 1897 4 0 -24.326282 5.920341 20.500508 +6920 1897 4 0 -24.274788 7.300563 19.971121 +6921 1898 6 0 -0.448883 -20.864583 -14.617458 +6922 1898 4 0 0.071192 -21.697111 -14.370110 +6923 1898 4 0 -0.336801 -20.602783 -15.491876 +6924 1899 6 0 4.752131 -18.759171 16.224472 +6925 1899 4 0 4.247100 -17.909089 16.159151 +6926 1899 4 0 5.497199 -18.596379 16.767517 +6927 1900 6 0 25.551466 11.024091 14.835821 +6928 1900 4 0 26.097565 10.360826 15.318240 +6929 1900 4 0 25.868265 11.894670 15.113284 +6930 1901 6 0 -13.792632 -0.131648 -11.968031 +6931 1901 4 0 -14.069742 -1.037349 -12.273373 +6932 1901 4 0 -14.587746 0.465719 -12.016945 +6933 1902 6 0 -2.710690 15.293627 -0.278680 +6934 1902 4 0 -2.998969 15.960057 0.331443 +6935 1902 4 0 -3.386842 14.623069 -0.355634 +6936 1903 6 0 -17.248233 -20.121844 -4.059452 +6937 1903 4 0 -17.172414 -21.044463 -4.251654 +6938 1903 4 0 -16.877225 -20.034684 -3.174803 +6939 1904 6 0 23.843575 9.736974 -14.350198 +6940 1904 4 0 23.682322 8.979239 -15.046519 +6941 1904 4 0 23.367386 9.481782 -13.520758 +6942 1905 6 0 -11.977920 -13.866924 -9.096345 +6943 1905 4 0 -12.034457 -14.762049 -8.738542 +6944 1905 4 0 -11.033924 -13.842490 -9.319192 +6945 1906 6 0 -20.844885 -20.673768 11.904219 +6946 1906 4 0 -21.211544 -21.565612 12.158518 +6947 1906 4 0 -21.251746 -20.526654 11.038182 +6948 1907 6 0 10.501648 -10.083276 10.087293 +6949 1907 4 0 10.918566 -9.250606 10.394612 +6950 1907 4 0 9.992333 -9.906650 9.274003 +6951 1908 6 0 -19.115579 -4.779064 -19.789173 +6952 1908 4 0 -18.214269 -4.399767 -19.923178 +6953 1908 4 0 -19.400662 -4.666966 -18.902157 +6954 1909 6 0 27.292959 4.591920 -14.450094 +6955 1909 4 0 27.857326 4.638750 -13.673258 +6956 1909 4 0 26.302663 4.467257 -14.132617 +6957 1910 6 0 -15.973482 -19.623868 10.652463 +6958 1910 4 0 -15.396164 -19.929927 9.974366 +6959 1910 4 0 -16.843194 -19.544182 10.235192 +6960 1911 6 0 -24.224954 -2.728737 10.935846 +6961 1911 4 0 -23.262685 -2.710705 11.036848 +6962 1911 4 0 -24.594330 -3.621981 10.847310 +6963 1912 6 0 -10.392772 -14.962488 2.206954 +6964 1912 4 0 -10.142273 -15.819733 2.617268 +6965 1912 4 0 -9.689412 -14.869628 1.550246 +6966 1913 6 0 23.781651 14.549010 -15.425504 +6967 1913 4 0 23.508500 15.178591 -16.172525 +6968 1913 4 0 23.231402 13.779403 -15.566088 +6969 1914 6 0 -16.655122 13.378532 -2.256893 +6970 1914 4 0 -15.876557 13.842392 -1.809556 +6971 1914 4 0 -17.352965 14.010234 -2.115536 +6972 1915 6 0 17.907598 17.234287 -12.510154 +6973 1915 4 0 17.700495 16.802779 -13.342124 +6974 1915 4 0 17.297348 17.961204 -12.489351 +6975 1916 6 0 17.427023 -12.078823 9.916700 +6976 1916 4 0 16.525879 -12.070244 9.636554 +6977 1916 4 0 17.909679 -12.239509 9.119337 +6978 1917 6 0 -19.359847 6.057050 19.624868 +6979 1917 4 0 -19.814369 5.574360 18.904014 +6980 1917 4 0 -19.255770 6.911903 19.182635 +6981 1918 6 0 18.674024 -19.624270 17.522963 +6982 1918 4 0 17.740156 -19.461855 17.682137 +6983 1918 4 0 18.867385 -19.535332 16.599150 +6984 1919 6 0 20.025827 3.814045 -9.622919 +6985 1919 4 0 19.683972 4.038069 -10.485997 +6986 1919 4 0 20.937506 3.543209 -9.811005 +6987 1920 6 0 5.470940 6.984171 8.109869 +6988 1920 4 0 5.850717 7.846581 8.087996 +6989 1920 4 0 5.945843 6.559192 8.827716 +6990 1921 6 0 -10.808039 20.531242 -16.312076 +6991 1921 4 0 -10.302470 21.104206 -15.760708 +6992 1921 4 0 -10.017446 20.227222 -16.784699 +6993 1922 6 0 -11.027875 -4.920821 17.870938 +6994 1922 4 0 -10.325336 -4.445713 17.369166 +6995 1922 4 0 -11.377886 -5.529192 17.224974 +6996 1923 6 0 -20.371671 10.114815 16.255481 +6997 1923 4 0 -20.580138 10.101355 15.263993 +6998 1923 4 0 -20.344545 11.071578 16.437819 +6999 1924 6 0 23.653520 3.436168 1.325510 +7000 1924 4 0 23.536106 2.474980 1.098717 +7001 1924 4 0 23.860683 3.796523 0.414552 +7002 1925 6 0 -21.567514 -2.949387 5.091162 +7003 1925 4 0 -22.071317 -3.738968 4.916553 +7004 1925 4 0 -22.336939 -2.390166 5.390630 +7005 1926 6 0 22.554166 -9.402044 -6.100872 +7006 1926 4 0 23.431323 -9.766839 -6.077907 +7007 1926 4 0 22.697180 -8.479613 -6.418284 +7008 1927 6 0 -22.569113 -4.640399 13.826281 +7009 1927 4 0 -23.358557 -5.049193 13.550678 +7010 1927 4 0 -22.257880 -5.191735 14.515317 +7011 1928 6 0 -2.385157 12.751460 -2.313524 +7012 1928 4 0 -1.730031 13.357140 -2.644514 +7013 1928 4 0 -1.978595 12.282671 -1.585523 +7014 1929 6 0 -26.161645 14.565358 1.232440 +7015 1929 4 0 -26.706603 13.814255 1.347347 +7016 1929 4 0 -26.622850 15.329972 1.567273 +7017 1930 6 0 1.453589 -9.489501 -18.511074 +7018 1930 4 0 1.470127 -10.349425 -18.991155 +7019 1930 4 0 1.973543 -8.965754 -19.091787 +7020 1931 6 0 -0.660378 -18.577536 -12.938447 +7021 1931 4 0 -0.732583 -19.053338 -12.113581 +7022 1931 4 0 -0.517701 -19.272917 -13.578982 +7023 1932 6 0 14.312654 12.150861 -6.246651 +7024 1932 4 0 14.287806 12.704737 -5.491569 +7025 1932 4 0 15.175580 11.801455 -6.299294 +7026 1933 6 0 18.998590 6.532260 -0.632888 +7027 1933 4 0 18.366049 5.787028 -0.799484 +7028 1933 4 0 19.311853 6.485139 0.272589 +7029 1934 6 0 5.329915 17.883588 20.342830 +7030 1934 4 0 4.796701 18.410992 19.709020 +7031 1934 4 0 4.770971 17.852635 21.154570 +7032 1935 6 0 24.723592 -6.944303 -11.741165 +7033 1935 4 0 24.780327 -6.008688 -11.867155 +7034 1935 4 0 24.690407 -7.329055 -12.639425 +7035 1936 6 0 -23.122003 4.618796 18.181339 +7036 1936 4 0 -23.209287 5.265752 18.869409 +7037 1936 4 0 -23.988906 4.549652 17.803581 +7038 1937 6 0 8.709146 17.478249 5.929770 +7039 1937 4 0 7.992855 18.166454 5.872705 +7040 1937 4 0 9.532770 18.014027 5.879190 +7041 1938 6 0 -25.145193 10.967387 14.467030 +7042 1938 4 0 -25.638192 11.462461 13.811080 +7043 1938 4 0 -25.115880 11.602045 15.194844 +7044 1939 6 0 -6.270672 10.298692 -9.326284 +7045 1939 4 0 -6.326041 9.841909 -8.460997 +7046 1939 4 0 -5.298295 10.155581 -9.629880 +7047 1940 6 0 8.331282 15.667208 -4.044961 +7048 1940 4 0 8.081425 16.068754 -3.248975 +7049 1940 4 0 7.784433 16.176579 -4.661216 +7050 1941 6 0 -4.605111 3.075866 17.330627 +7051 1941 4 0 -4.999875 2.960715 16.481841 +7052 1941 4 0 -5.159040 3.212840 18.083160 +7053 1942 6 0 14.687017 -3.513814 10.903431 +7054 1942 4 0 14.499277 -3.337699 11.823116 +7055 1942 4 0 14.262838 -4.331541 10.602044 +7056 1943 6 0 -20.872612 6.379762 10.816794 +7057 1943 4 0 -20.860809 7.234769 10.341581 +7058 1943 4 0 -20.061300 6.341520 11.384808 +7059 1944 6 0 7.161896 -4.360755 17.634105 +7060 1944 4 0 8.175987 -4.400233 17.464973 +7061 1944 4 0 7.057446 -4.853463 18.480499 +7062 1945 6 0 -3.475038 11.316770 16.798166 +7063 1945 4 0 -2.755042 10.845936 17.155120 +7064 1945 4 0 -3.489190 11.054731 15.856176 +7065 1946 6 0 15.663266 8.649743 3.198716 +7066 1946 4 0 15.359027 9.298705 3.810376 +7067 1946 4 0 16.192400 8.008866 3.672568 +7068 1947 6 0 5.436707 -20.461241 11.921265 +7069 1947 4 0 5.119701 -19.606856 11.530637 +7070 1947 4 0 4.713208 -20.630626 12.549382 +7071 1948 6 0 -4.801212 -17.868960 -3.936676 +7072 1948 4 0 -5.438715 -17.659702 -4.657529 +7073 1948 4 0 -4.229156 -18.589597 -4.194370 +7074 1949 6 0 -15.253442 11.238290 -10.212163 +7075 1949 4 0 -14.642285 11.918974 -10.588009 +7076 1949 4 0 -16.099309 11.643007 -10.393989 +7077 1950 6 0 26.686176 10.830985 20.584564 +7078 1950 4 0 26.369951 11.360874 21.358365 +7079 1950 4 0 26.509688 9.944710 20.906243 +7080 1951 6 0 12.561683 17.569279 18.161912 +7081 1951 4 0 12.373224 16.635553 17.927044 +7082 1951 4 0 11.953579 17.940076 18.749558 +7083 1952 6 0 -7.212093 -10.307008 17.334494 +7084 1952 4 0 -6.512620 -10.511909 17.944932 +7085 1952 4 0 -7.614860 -11.144180 17.014381 +7086 1953 6 0 1.066613 3.381658 18.538737 +7087 1953 4 0 1.472142 3.810443 19.302366 +7088 1953 4 0 0.121217 3.213227 18.686468 +7089 1954 6 0 26.591569 20.388220 15.314096 +7090 1954 4 0 27.027629 19.549241 15.003737 +7091 1954 4 0 25.677162 20.106742 15.492223 +7092 1955 6 0 -12.980829 3.037173 -5.149300 +7093 1955 4 0 -13.518049 2.271141 -5.381098 +7094 1955 4 0 -13.015144 3.271986 -4.233059 +7095 1956 6 0 -15.670290 -19.461795 -8.693893 +7096 1956 4 0 -15.312346 -19.371467 -7.762922 +7097 1956 4 0 -15.700912 -18.579237 -9.112271 +7098 1957 6 0 18.498310 -6.951013 11.923309 +7099 1957 4 0 19.331146 -6.980278 12.293062 +7100 1957 4 0 17.952458 -6.708175 12.679535 +7101 1958 6 0 22.848965 14.115566 0.206953 +7102 1958 4 0 23.127347 14.768732 -0.415947 +7103 1958 4 0 23.434401 14.218348 0.991573 +7104 1959 6 0 -23.977260 16.643521 -8.138268 +7105 1959 4 0 -24.563932 16.858836 -8.896849 +7106 1959 4 0 -23.095154 16.760370 -8.386216 +7107 1960 6 0 -26.584391 -6.397854 5.547650 +7108 1960 4 0 -25.925294 -7.061435 5.741608 +7109 1960 4 0 -26.133892 -5.544387 5.442967 +7110 1961 6 0 2.060216 -10.468459 10.640375 +7111 1961 4 0 2.489904 -9.711105 10.219505 +7112 1961 4 0 1.131111 -10.283322 10.616360 +7113 1962 6 0 5.954667 9.758583 -20.555530 +7114 1962 4 0 6.264304 10.543474 -21.120622 +7115 1962 4 0 5.484413 9.147185 -21.197897 +7116 1963 6 0 24.786566 -15.292270 2.666103 +7117 1963 4 0 23.947578 -15.213745 2.181575 +7118 1963 4 0 24.621364 -16.114647 3.180504 +7119 1964 6 0 -9.238549 4.246640 18.608373 +7120 1964 4 0 -8.516205 4.915950 18.512268 +7121 1964 4 0 -8.905672 3.343488 18.421048 +7122 1965 6 0 4.458783 0.783326 15.910622 +7123 1965 4 0 4.333357 -0.156607 15.829450 +7124 1965 4 0 5.377583 0.813141 16.228468 +7125 1966 6 0 2.440654 19.498822 -16.520052 +7126 1966 4 0 1.894281 18.987314 -15.882707 +7127 1966 4 0 2.550447 18.871750 -17.222238 +7128 1967 6 0 -14.387304 8.489545 5.108260 +7129 1967 4 0 -14.330824 9.314254 5.570879 +7130 1967 4 0 -13.611936 7.964241 5.306370 +7131 1968 6 0 -5.680779 -19.561928 -0.391390 +7132 1968 4 0 -6.492940 -19.118143 -0.731363 +7133 1968 4 0 -5.761503 -20.446667 -0.611520 +7134 1969 6 0 0.364483 -0.976730 20.596640 +7135 1969 4 0 0.190818 -1.943299 20.568078 +7136 1969 4 0 -0.296384 -0.570410 19.967598 +7137 1970 6 0 -20.103572 15.327950 -3.864750 +7138 1970 4 0 -20.721760 16.087200 -3.977948 +7139 1970 4 0 -19.620299 15.411599 -4.730333 +7140 1971 6 0 7.762229 -15.911349 -12.044815 +7141 1971 4 0 8.618390 -15.446157 -11.951239 +7142 1971 4 0 8.056718 -16.844883 -11.932849 +7143 1972 6 0 -14.271772 -19.114636 20.444087 +7144 1972 4 0 -13.631359 -18.451185 20.013255 +7145 1972 4 0 -14.788312 -18.613074 21.058254 +7146 1973 6 0 -17.296785 -16.270141 -5.846230 +7147 1973 4 0 -16.661324 -16.986407 -5.791657 +7148 1973 4 0 -17.698563 -16.270611 -6.699261 +7149 1974 6 0 5.461014 -17.908610 10.258639 +7150 1974 4 0 6.041339 -18.066045 9.495427 +7151 1974 4 0 5.907462 -17.113295 10.672048 +7152 1975 6 0 -6.579640 -20.864919 -3.728078 +7153 1975 4 0 -6.197014 -21.129682 -2.892954 +7154 1975 4 0 -5.867159 -20.529771 -4.364102 +7155 1976 6 0 15.290566 -16.899037 3.541007 +7156 1976 4 0 15.456923 -17.854501 3.506824 +7157 1976 4 0 14.682578 -16.661722 4.258103 +7158 1977 6 0 -8.595092 -1.638190 20.084084 +7159 1977 4 0 -8.261779 -2.590969 20.168832 +7160 1977 4 0 -7.852015 -1.108351 20.332316 +7161 1978 6 0 -20.323788 -5.436750 0.324161 +7162 1978 4 0 -20.170009 -5.941054 1.094644 +7163 1978 4 0 -21.208252 -5.031900 0.601954 +7164 1979 6 0 -2.393237 8.004242 -11.498413 +7165 1979 4 0 -2.950404 8.660356 -11.054135 +7166 1979 4 0 -3.061318 7.581791 -12.073133 +7167 1980 6 0 -22.912771 3.860494 -12.441206 +7168 1980 4 0 -23.451777 3.037762 -12.348507 +7169 1980 4 0 -22.899565 4.032930 -13.430208 +7170 1981 6 0 20.362995 17.824512 -13.264003 +7171 1981 4 0 19.551615 17.496626 -12.844707 +7172 1981 4 0 20.082478 18.300222 -14.079166 +7173 1982 6 0 -24.585913 -0.746630 -0.896798 +7174 1982 4 0 -24.470331 -1.075027 -1.802806 +7175 1982 4 0 -23.819676 -0.946255 -0.373167 +7176 1983 6 0 -19.535789 -9.056148 -13.988499 +7177 1983 4 0 -19.846462 -8.673779 -13.166776 +7178 1983 4 0 -19.115510 -8.309283 -14.534612 +7179 1984 6 0 14.390022 6.679518 12.730957 +7180 1984 4 0 15.232081 6.289813 12.946155 +7181 1984 4 0 14.506655 7.667961 12.798775 +7182 1985 6 0 -13.116074 -0.366672 20.319004 +7183 1985 4 0 -12.270792 -0.638533 19.918398 +7184 1985 4 0 -13.671647 -1.133311 20.295523 +7185 1986 6 0 -8.591511 -19.336122 8.863799 +7186 1986 4 0 -9.117090 -20.010877 8.426692 +7187 1986 4 0 -7.862918 -19.753372 9.330648 +7188 1987 6 0 17.402278 20.652639 13.900402 +7189 1987 4 0 17.697788 21.603581 13.957892 +7190 1987 4 0 17.312316 20.500438 12.944824 +7191 1988 6 0 8.201262 9.483818 13.348516 +7192 1988 4 0 7.444873 10.096390 13.607594 +7193 1988 4 0 8.957598 10.011937 13.627746 +7194 1989 6 0 7.585535 14.800848 -12.327563 +7195 1989 4 0 7.057327 14.353832 -11.664194 +7196 1989 4 0 7.019891 15.502887 -12.695142 +7197 1990 6 0 -25.423194 -2.683175 -19.281520 +7198 1990 4 0 -25.154720 -3.154251 -18.493055 +7199 1990 4 0 -24.615481 -2.633480 -19.773081 +7200 1991 6 0 19.725045 -13.114787 8.444878 +7201 1991 4 0 19.513124 -14.034339 8.634210 +7202 1991 4 0 20.698306 -13.102042 8.543928 +7203 1992 6 0 20.099503 -20.282525 -15.985101 +7204 1992 4 0 20.708189 -19.889578 -15.319196 +7205 1992 4 0 19.393142 -19.575319 -15.986140 +7206 1993 6 0 12.771061 16.100563 -19.111418 +7207 1993 4 0 12.131597 16.778356 -19.314806 +7208 1993 4 0 12.464661 15.303336 -19.572804 +7209 1994 6 0 7.091753 -14.703139 17.991009 +7210 1994 4 0 7.807603 -15.309333 17.938259 +7211 1994 4 0 7.194027 -14.118016 17.231754 +7212 1995 6 0 -22.592481 8.686176 -7.047127 +7213 1995 4 0 -22.216240 9.064017 -6.202984 +7214 1995 4 0 -23.491060 9.070100 -7.232883 +7215 1996 6 0 -4.638462 -13.691402 17.535113 +7216 1996 4 0 -4.741933 -14.552763 17.998987 +7217 1996 4 0 -3.917812 -13.768318 16.891949 +7218 1997 6 0 15.674081 -9.755387 -16.113189 +7219 1997 4 0 16.400378 -9.301702 -15.729512 +7220 1997 4 0 15.141124 -9.061926 -16.542582 +7221 1998 6 0 -13.702316 -19.909047 -12.268941 +7222 1998 4 0 -14.359478 -19.319853 -12.555858 +7223 1998 4 0 -14.123812 -20.688800 -11.912022 +7224 1999 6 0 24.541571 12.760808 8.882057 +7225 1999 4 0 24.177431 13.512218 9.353984 +7226 1999 4 0 24.288780 12.867460 7.942115 +7227 2000 6 0 -7.687548 20.108508 10.397741 +7228 2000 4 0 -6.786045 20.459581 10.465576 +7229 2000 4 0 -7.840032 19.590481 9.619893 +7230 2001 6 0 17.691564 14.211194 -11.948720 +7231 2001 4 0 16.837678 14.621970 -11.842799 +7232 2001 4 0 18.118330 14.755742 -12.626475 +7233 2002 6 0 21.348057 -7.329463 -13.375832 +7234 2002 4 0 21.593345 -6.492239 -13.815720 +7235 2002 4 0 21.736068 -7.343951 -12.513154 +7236 2003 6 0 -19.887601 4.039241 4.011716 +7237 2003 4 0 -20.804227 3.899388 4.382950 +7238 2003 4 0 -19.888370 5.029157 3.892591 +7239 2004 6 0 -25.084134 8.583682 -19.308703 +7240 2004 4 0 -25.512658 8.302589 -20.191094 +7241 2004 4 0 -24.552230 7.802502 -19.104750 +7242 2005 6 0 9.783143 -8.944234 15.919722 +7243 2005 4 0 9.846305 -9.847677 16.313657 +7244 2005 4 0 10.422901 -8.539313 16.532052 +7245 2006 6 0 24.921152 14.233454 -9.328043 +7246 2006 4 0 25.485037 14.435637 -8.538860 +7247 2006 4 0 24.550831 15.052607 -9.617520 +7248 2007 6 0 -5.336150 -19.944956 -15.675499 +7249 2007 4 0 -4.550070 -20.475028 -15.352798 +7250 2007 4 0 -4.968558 -19.050199 -15.973828 +7251 2008 6 0 -15.773463 -12.281833 -13.129558 +7252 2008 4 0 -15.686354 -12.889867 -12.384071 +7253 2008 4 0 -15.452029 -12.783419 -13.894154 +7254 2009 6 0 -4.300139 -7.123836 -2.160106 +7255 2009 4 0 -3.342814 -7.235681 -2.390788 +7256 2009 4 0 -4.824947 -7.659223 -2.750865 +7257 2010 6 0 -25.789560 20.874236 19.526065 +7258 2010 4 0 -24.843357 21.124661 19.555308 +7259 2010 4 0 -26.065421 21.149679 18.673765 +7260 2011 6 0 -9.146229 1.424908 -20.523854 +7261 2011 4 0 -10.001499 1.119683 -20.181523 +7262 2011 4 0 -8.546249 0.921170 -20.019617 +7263 2012 6 0 26.101075 5.848590 12.988450 +7264 2012 4 0 26.554693 5.084410 12.637458 +7265 2012 4 0 25.161381 5.669725 12.803554 +7266 2013 6 0 9.006687 19.040346 -18.186210 +7267 2013 4 0 8.065932 18.907108 -18.115528 +7268 2013 4 0 9.047297 19.909251 -18.666859 +7269 2014 6 0 -7.293872 14.178171 -1.883075 +7270 2014 4 0 -6.467767 14.351226 -2.386146 +7271 2014 4 0 -7.610529 15.055318 -1.621187 +7272 2015 6 0 -6.991462 19.787403 0.500962 +7273 2015 4 0 -6.438660 19.949638 1.223968 +7274 2015 4 0 -7.711116 19.103046 0.704655 +7275 2016 6 0 27.160597 -2.308726 -10.478195 +7276 2016 4 0 26.892593 -1.628933 -9.894058 +7277 2016 4 0 26.370866 -2.910166 -10.699907 +7278 2017 6 0 20.720937 15.282200 -14.602248 +7279 2017 4 0 19.787625 15.378072 -14.861312 +7280 2017 4 0 21.253153 16.033456 -14.917484 +7281 2018 6 0 -1.717777 3.126430 19.684869 +7282 2018 4 0 -2.457020 3.742545 19.704262 +7283 2018 4 0 -1.981408 2.239558 19.670325 +7284 2019 6 0 -14.236932 -8.531350 -17.888137 +7285 2019 4 0 -13.483311 -8.743594 -17.293313 +7286 2019 4 0 -14.879621 -9.247417 -17.747177 +7287 2020 6 0 -4.783415 -4.020396 -20.532866 +7288 2020 4 0 -4.012136 -4.566525 -20.414031 +7289 2020 4 0 -5.530185 -4.500179 -20.351823 +7290 2021 6 0 -13.666695 2.341198 -19.917613 +7291 2021 4 0 -13.647430 2.522072 -20.842149 +7292 2021 4 0 -14.523681 2.756089 -19.651511 +7293 2022 6 0 3.688675 -20.632144 14.338255 +7294 2022 4 0 4.124765 -20.055049 14.958708 +7295 2022 4 0 3.773276 -21.474844 14.693545 +7296 2023 6 0 -20.711810 11.153254 -5.295425 +7297 2023 4 0 -20.997628 10.543621 -4.576628 +7298 2023 4 0 -20.872806 11.978037 -4.877765 +7299 2024 6 0 24.053294 -19.987538 -18.448521 +7300 2024 4 0 23.997797 -20.379984 -19.321399 +7301 2024 4 0 24.605029 -20.616521 -17.920358 +7302 2025 6 0 18.893096 0.346665 4.419514 +7303 2025 4 0 18.836810 -0.563948 4.138422 +7304 2025 4 0 19.384494 0.416823 5.258191 +7305 2026 6 0 1.611674 7.827775 17.729516 +7306 2026 4 0 1.683155 6.883076 17.518073 +7307 2026 4 0 0.776664 7.948423 18.173512 +7308 2027 6 0 9.885872 -10.367999 -15.423519 +7309 2027 4 0 9.747228 -11.080640 -16.152068 +7310 2027 4 0 9.165955 -9.782881 -15.477159 +7311 2028 6 0 -8.001025 -8.903978 20.363588 +7312 2028 4 0 -7.919331 -9.384725 21.262606 +7313 2028 4 0 -8.555002 -9.547097 19.892421 +7314 2029 6 0 -5.444250 -12.618432 -20.512332 +7315 2029 4 0 -4.642289 -13.086364 -20.688100 +7316 2029 4 0 -5.443229 -12.055754 -19.736438 +7317 2030 6 0 13.515262 -10.012095 19.152766 +7318 2030 4 0 12.845808 -9.927516 19.858658 +7319 2030 4 0 14.340617 -9.646593 19.590648 +7320 2031 6 0 -8.356973 -7.803379 16.925718 +7321 2031 4 0 -8.140830 -7.917106 15.999678 +7322 2031 4 0 -8.084091 -8.687693 17.308394 +7323 2032 6 0 19.760910 -2.370831 2.421662 +7324 2032 4 0 20.560599 -1.857333 2.578796 +7325 2032 4 0 19.273809 -1.863655 1.723372 +7326 2033 6 0 16.532929 9.397948 -13.603509 +7327 2033 4 0 16.407542 10.353638 -13.545246 +7328 2033 4 0 17.450225 9.202690 -13.801843 +7329 2034 6 0 3.043298 -8.545676 8.964253 +7330 2034 4 0 2.418694 -7.834314 8.742863 +7331 2034 4 0 3.163757 -8.907052 8.081541 +7332 2035 6 0 -5.314921 -13.601995 0.201579 +7333 2035 4 0 -4.416708 -13.534559 -0.042940 +7334 2035 4 0 -5.417418 -14.438498 0.657175 +7335 2036 6 0 1.416185 6.843538 -11.410595 +7336 2036 4 0 1.633970 7.742217 -11.087491 +7337 2036 4 0 0.761793 6.459053 -10.786036 +7338 2037 6 0 19.767922 9.421307 -8.193013 +7339 2037 4 0 19.914480 8.466041 -8.135440 +7340 2037 4 0 19.575103 9.558308 -9.177735 +7341 2038 6 0 26.172410 11.919029 3.610739 +7342 2038 4 0 25.535585 12.193435 4.240735 +7343 2038 4 0 26.042272 10.983029 3.549151 +7344 2039 6 0 -21.735841 2.144400 18.211620 +7345 2039 4 0 -22.104009 2.960860 18.654752 +7346 2039 4 0 -22.313927 1.460249 18.492995 +7347 2040 6 0 1.557972 -12.790578 15.622137 +7348 2040 4 0 0.853719 -13.365055 15.935999 +7349 2040 4 0 1.906483 -13.231160 14.910699 +7350 2041 6 0 -13.258859 4.104211 -2.315588 +7351 2041 4 0 -13.608254 4.812418 -2.986967 +7352 2041 4 0 -14.087487 3.646024 -2.095452 +7353 2042 6 0 -26.307679 -0.111768 -20.714469 +7354 2042 4 0 -25.812995 0.720645 -20.583269 +7355 2042 4 0 -25.528348 -0.678575 -20.909717 +7356 2043 6 0 11.642962 12.398152 -6.461792 +7357 2043 4 0 11.596820 12.230702 -5.538685 +7358 2043 4 0 12.552221 12.400971 -6.683261 +7359 2044 6 0 9.805562 12.056033 0.297197 +7360 2044 4 0 10.657658 12.469311 0.654830 +7361 2044 4 0 9.202541 11.759951 0.941289 +7362 2045 6 0 -6.826832 12.393010 9.213697 +7363 2045 4 0 -6.537792 11.811004 8.506850 +7364 2045 4 0 -6.100427 12.347418 9.835231 +7365 2046 6 0 20.133141 -17.531986 18.955618 +7366 2046 4 0 19.437169 -18.073233 18.517051 +7367 2046 4 0 20.798807 -17.276415 18.236384 +7368 2047 6 0 16.549382 -10.626162 16.457286 +7369 2047 4 0 16.551942 -9.717820 16.759418 +7370 2047 4 0 16.147566 -11.023294 17.252231 +7371 2048 6 0 1.789829 14.643494 -5.619552 +7372 2048 4 0 1.048933 14.228176 -6.039228 +7373 2048 4 0 1.669053 14.391952 -4.707740 +7374 2049 6 0 4.371658 -12.694698 -12.318562 +7375 2049 4 0 4.915573 -13.184619 -11.694576 +7376 2049 4 0 4.915130 -11.958781 -12.720896 +7377 2050 6 0 -11.293082 0.237019 -19.250596 +7378 2050 4 0 -11.966255 0.783547 -19.678369 +7379 2050 4 0 -11.548510 -0.704739 -19.364586 +7380 2051 6 0 -2.484806 -0.918295 -14.668621 +7381 2051 4 0 -2.177091 -1.152345 -15.589201 +7382 2051 4 0 -1.695025 -0.610144 -14.221845 +7383 2052 6 0 25.578482 -18.001184 -14.174826 +7384 2052 4 0 24.716923 -17.519582 -14.309086 +7385 2052 4 0 26.303012 -17.438870 -14.436407 +7386 2053 6 0 23.132217 17.040870 -8.595297 +7387 2053 4 0 23.143509 17.518773 -7.762629 +7388 2053 4 0 22.923741 16.132690 -8.372110 +7389 2054 6 0 2.923503 11.871856 -20.547177 +7390 2054 4 0 2.198503 11.234695 -20.236214 +7391 2054 4 0 3.511763 11.911115 -19.844001 +7392 2055 6 0 2.179585 4.144910 -11.877852 +7393 2055 4 0 2.151655 5.096818 -11.803012 +7394 2055 4 0 2.729899 3.974673 -12.667805 +7395 2056 6 0 26.669404 -11.624549 13.477594 +7396 2056 4 0 25.735733 -11.431455 13.654851 +7397 2056 4 0 27.077849 -11.550313 14.372992 +7398 2057 6 0 24.873075 -11.097731 10.824618 +7399 2057 4 0 25.209728 -11.897467 10.432443 +7400 2057 4 0 25.614915 -10.682030 11.193580 +7401 2058 6 0 -1.826162 -17.791623 4.511609 +7402 2058 4 0 -1.466714 -17.114337 3.985489 +7403 2058 4 0 -1.066332 -18.298254 4.813832 +7404 2059 6 0 24.895806 4.512131 -17.916870 +7405 2059 4 0 24.133889 5.103597 -18.006070 +7406 2059 4 0 25.725831 4.889044 -18.163865 +7407 2060 6 0 -20.306217 1.655909 -0.658591 +7408 2060 4 0 -19.365596 1.457605 -0.837148 +7409 2060 4 0 -20.259907 1.991986 0.211928 +7410 2061 6 0 13.312009 19.524936 16.387048 +7411 2061 4 0 13.933293 19.167357 15.722455 +7412 2061 4 0 13.259660 18.816564 17.092867 +7413 2062 6 0 -6.291960 0.181353 20.409012 +7414 2062 4 0 -5.886986 -0.391564 19.697954 +7415 2062 4 0 -6.191361 -0.287042 21.246927 +7416 2063 6 0 -11.925605 -14.118393 11.513337 +7417 2063 4 0 -12.390021 -13.899494 10.677619 +7418 2063 4 0 -11.499213 -13.318961 11.825704 +7419 2064 6 0 25.690900 -20.544963 -6.726643 +7420 2064 4 0 25.848636 -19.865858 -7.443635 +7421 2064 4 0 25.541265 -21.356361 -7.237324 +7422 2065 6 0 -10.266763 4.606069 -14.148088 +7423 2065 4 0 -10.666583 4.007171 -14.802051 +7424 2065 4 0 -10.592890 5.506386 -14.316808 +7425 2066 6 0 -13.700313 11.443217 -7.703372 +7426 2066 4 0 -14.305805 11.566376 -8.451855 +7427 2066 4 0 -13.797593 10.519533 -7.520760 +7428 2067 6 0 19.896960 -5.260769 2.047938 +7429 2067 4 0 20.639909 -5.673868 2.498703 +7430 2067 4 0 19.902578 -4.275845 1.972121 +7431 2068 6 0 27.483595 4.667361 6.350280 +7432 2068 4 0 27.612327 3.821689 6.792070 +7433 2068 4 0 27.474096 5.241160 7.041075 +7434 2069 6 0 16.838162 -11.125573 -1.977415 +7435 2069 4 0 17.018636 -10.652759 -1.169733 +7436 2069 4 0 17.083147 -12.071800 -1.748280 +7437 2070 6 0 -3.825915 15.193309 16.332435 +7438 2070 4 0 -3.868970 16.088775 15.893612 +7439 2070 4 0 -2.922251 14.779372 16.138541 +7440 2071 6 0 -4.999597 -20.685905 -5.935566 +7441 2071 4 0 -5.618635 -20.401156 -6.580918 +7442 2071 4 0 -5.077868 -21.673790 -5.909799 +7443 2072 6 0 -20.562039 0.140160 5.669443 +7444 2072 4 0 -20.686050 0.843366 6.344794 +7445 2072 4 0 -20.730893 0.582485 4.804185 +7446 2073 6 0 -6.671827 11.535978 19.876374 +7447 2073 4 0 -7.261521 11.364859 20.662982 +7448 2073 4 0 -7.266511 12.144069 19.377508 +7449 2074 6 0 4.191517 -2.479488 13.355524 +7450 2074 4 0 4.884007 -2.164404 14.019008 +7451 2074 4 0 3.372874 -2.220309 13.814811 +7452 2075 6 0 8.749947 16.191041 8.535964 +7453 2075 4 0 8.732297 16.863275 9.229059 +7454 2075 4 0 8.691576 16.634682 7.644507 +7455 2076 6 0 -25.961494 14.282183 -15.383787 +7456 2076 4 0 -25.985646 15.282436 -15.164995 +7457 2076 4 0 -26.833664 13.915918 -15.151600 +7458 2077 6 0 27.385198 14.529212 8.142639 +7459 2077 4 0 26.412128 14.399556 8.083311 +7460 2077 4 0 27.495002 15.490751 8.294493 +7461 2078 6 0 14.126472 -14.702927 -8.987957 +7462 2078 4 0 14.925682 -14.560974 -8.448204 +7463 2078 4 0 13.489976 -15.067821 -8.401821 +7464 2079 6 0 -23.336636 -6.121383 -20.639900 +7465 2079 4 0 -22.869154 -5.535755 -20.072156 +7466 2079 4 0 -24.124908 -6.450781 -20.113919 +7467 2080 6 0 -0.774826 -13.203604 16.888646 +7468 2080 4 0 -1.468020 -13.376023 16.234547 +7469 2080 4 0 -0.931871 -12.304587 17.229608 +7470 2081 6 0 9.061125 5.283331 17.143683 +7471 2081 4 0 9.916783 5.174639 16.603587 +7472 2081 4 0 8.778289 6.220910 17.070877 +7473 2082 6 0 -25.315423 9.781118 -15.359265 +7474 2082 4 0 -24.471315 9.264358 -15.331486 +7475 2082 4 0 -25.606191 9.792640 -14.434801 +7476 2083 6 0 -10.967554 -10.738154 -9.731527 +7477 2083 4 0 -11.765483 -10.936834 -9.181748 +7478 2083 4 0 -10.379375 -10.133651 -9.266538 +7479 2084 6 0 -1.488275 3.623351 -16.767913 +7480 2084 4 0 -0.882657 4.371387 -16.669247 +7481 2084 4 0 -1.492403 3.254437 -17.674715 +7482 2085 6 0 12.452312 -19.040060 3.375147 +7483 2085 4 0 12.871486 -19.871899 3.246114 +7484 2085 4 0 11.754508 -18.893125 2.776534 +7485 2086 6 0 -15.573729 -12.221722 0.716973 +7486 2086 4 0 -15.002380 -12.832434 0.254063 +7487 2086 4 0 -16.254430 -12.772029 1.034977 +7488 2087 6 0 13.752256 -4.097413 -18.870896 +7489 2087 4 0 14.581949 -3.712772 -18.513163 +7490 2087 4 0 13.271688 -3.261042 -18.845949 +7491 2088 6 0 -21.641111 -0.680590 0.005430 +7492 2088 4 0 -21.093432 0.076279 -0.365044 +7493 2088 4 0 -21.445828 -0.814377 0.968664 +7494 2089 6 0 15.724559 3.520455 6.328412 +7495 2089 4 0 14.921141 3.234676 6.784467 +7496 2089 4 0 15.461693 3.698167 5.450324 +7497 2090 6 0 -27.214078 -11.147965 5.082767 +7498 2090 4 0 -26.390239 -11.278816 5.572480 +7499 2090 4 0 -27.321203 -12.054005 4.683669 +7500 2091 6 0 13.328280 7.582484 -18.567300 +7501 2091 4 0 14.185844 7.864153 -18.950423 +7502 2091 4 0 12.732777 7.507446 -19.290185 +7503 2092 6 0 -16.683838 -4.586561 -13.916725 +7504 2092 4 0 -16.820834 -4.523796 -14.842726 +7505 2092 4 0 -15.965498 -5.193692 -13.685180 +7506 2093 6 0 -19.170260 12.551147 12.092952 +7507 2093 4 0 -19.387562 11.609567 12.048568 +7508 2093 4 0 -18.718827 12.726237 11.286473 +7509 2094 6 0 -2.873940 -18.817391 -0.630738 +7510 2094 4 0 -2.585106 -18.870724 -1.613607 +7511 2094 4 0 -3.793192 -19.000736 -0.761036 +7512 2095 6 0 -15.440453 11.669180 16.607856 +7513 2095 4 0 -15.211613 10.749409 16.748182 +7514 2095 4 0 -15.523689 11.929189 17.511524 +7515 2096 6 0 0.676885 9.019049 7.967361 +7516 2096 4 0 -0.188437 8.924038 8.296825 +7517 2096 4 0 1.100577 8.314509 8.389075 +7518 2097 6 0 -12.658914 -13.169855 -2.443871 +7519 2097 4 0 -13.329719 -13.325087 -1.824892 +7520 2097 4 0 -12.438077 -13.988972 -2.754186 +7521 2098 6 0 -16.248882 -11.627131 16.273828 +7522 2098 4 0 -16.071661 -12.035171 17.149648 +7523 2098 4 0 -15.584055 -10.905357 16.247158 +7524 2099 6 0 7.587639 18.040490 0.648325 +7525 2099 4 0 7.127313 17.621736 1.427370 +7526 2099 4 0 8.472509 18.025945 0.938181 +7527 2100 6 0 -21.260403 -7.316165 -17.769548 +7528 2100 4 0 -21.464936 -6.579095 -18.356837 +7529 2100 4 0 -21.090642 -6.945093 -16.896335 +7530 2101 6 0 16.016635 -1.860641 -2.314369 +7531 2101 4 0 16.938184 -1.677711 -2.476393 +7532 2101 4 0 15.526197 -1.857629 -3.158683 +7533 2102 6 0 4.492292 -4.776655 -20.071507 +7534 2102 4 0 4.666835 -4.194018 -19.383577 +7535 2102 4 0 5.379154 -5.033244 -20.511472 +7536 2103 6 0 -15.720931 20.128785 -10.578428 +7537 2103 4 0 -15.839702 20.941641 -10.100642 +7538 2103 4 0 -16.315376 20.178519 -11.349297 +7539 2104 6 0 -26.439198 6.163682 -9.860618 +7540 2104 4 0 -25.627768 6.495816 -9.484731 +7541 2104 4 0 -26.911803 6.981208 -10.036013 +7542 2105 6 0 9.335945 11.329795 -3.722917 +7543 2105 4 0 8.644451 12.059424 -3.617751 +7544 2105 4 0 8.888513 10.554570 -4.126032 +7545 2106 6 0 -13.380471 10.478242 6.861111 +7546 2106 4 0 -13.220641 10.103750 7.786550 +7547 2106 4 0 -13.207886 11.438191 6.902907 +7548 2107 6 0 3.128674 -13.794262 17.620598 +7549 2107 4 0 2.638158 -13.260660 17.056399 +7550 2107 4 0 3.597573 -13.167888 18.155001 +7551 2108 6 0 -15.640110 12.239687 19.252890 +7552 2108 4 0 -15.744305 13.228589 19.346365 +7553 2108 4 0 -16.382496 11.838747 19.767704 +7554 2109 6 0 2.784908 9.116859 -10.197973 +7555 2109 4 0 3.297798 8.414513 -9.705521 +7556 2109 4 0 3.275248 9.528201 -10.883691 +7557 2110 6 0 -7.890712 -7.603783 -17.743202 +7558 2110 4 0 -7.124761 -7.008882 -17.935759 +7559 2110 4 0 -8.550851 -7.045750 -18.114982 +7560 2111 6 0 -13.699956 -6.291585 9.543158 +7561 2111 4 0 -14.665087 -6.196216 9.729838 +7562 2111 4 0 -13.399326 -5.367978 9.707420 +7563 2112 6 0 20.465588 -10.458716 3.145054 +7564 2112 4 0 20.979944 -10.701349 3.922596 +7565 2112 4 0 19.551694 -10.315318 3.519540 +7566 2113 6 0 -21.770772 17.965042 -17.112890 +7567 2113 4 0 -20.830189 18.026694 -16.817043 +7568 2113 4 0 -22.065602 18.901599 -17.079860 +7569 2114 6 0 -14.835473 -2.018047 -6.153382 +7570 2114 4 0 -15.436027 -2.198495 -6.881730 +7571 2114 4 0 -15.436197 -1.848312 -5.360006 +7572 2115 6 0 4.864928 -7.193456 16.503727 +7573 2115 4 0 4.980211 -6.246101 16.323915 +7574 2115 4 0 5.579734 -7.640000 16.024530 +7575 2116 6 0 19.120349 11.030815 -15.362470 +7576 2116 4 0 19.294800 10.826080 -16.279672 +7577 2116 4 0 19.622213 10.380633 -14.881548 +7578 2117 6 0 -0.977018 13.926628 -7.123442 +7579 2117 4 0 -1.852314 14.048847 -6.757564 +7580 2117 4 0 -1.008005 14.146864 -8.050474 +7581 2118 6 0 1.836955 20.649010 5.205237 +7582 2118 4 0 1.357046 19.856623 4.900209 +7583 2118 4 0 2.481382 20.946625 4.486330 +7584 2119 6 0 22.248352 0.089789 14.254305 +7585 2119 4 0 21.482126 0.622149 14.431275 +7586 2119 4 0 22.760633 -0.073685 15.065722 +7587 2120 6 0 4.943704 7.039238 -17.178880 +7588 2120 4 0 4.132510 7.341202 -17.610714 +7589 2120 4 0 5.316936 6.264192 -17.636046 +7590 2121 6 0 -13.513178 20.872697 -6.966661 +7591 2121 4 0 -12.917889 20.159554 -6.816410 +7592 2121 4 0 -13.438901 21.399519 -6.129707 +7593 2122 6 0 -26.783745 1.737872 -10.173855 +7594 2122 4 0 -27.406703 1.045834 -9.889439 +7595 2122 4 0 -26.563015 2.284868 -9.419251 +7596 2123 6 0 16.895897 -14.537239 -4.916419 +7597 2123 4 0 17.186118 -13.833540 -5.508216 +7598 2123 4 0 17.149098 -15.342322 -5.413605 +7599 2124 6 0 26.817205 -3.814990 8.332532 +7600 2124 4 0 26.423093 -3.721401 9.229654 +7601 2124 4 0 26.751966 -4.740274 8.261936 +7602 2125 6 0 26.660512 -8.107918 -18.699113 +7603 2125 4 0 27.143708 -8.664547 -19.302869 +7604 2125 4 0 27.318084 -7.817236 -18.086633 +7605 2126 6 0 10.208858 -14.799716 -11.685147 +7606 2126 4 0 10.229559 -13.857528 -11.605014 +7607 2126 4 0 10.909011 -14.996510 -12.361468 +7608 2127 6 0 -7.122161 12.606835 5.012358 +7609 2127 4 0 -6.742894 13.446553 5.343573 +7610 2127 4 0 -6.707272 11.958739 5.582727 +7611 2128 6 0 -1.649859 -17.353593 -19.765333 +7612 2128 4 0 -1.703196 -17.292489 -18.801764 +7613 2128 4 0 -0.740888 -17.269565 -19.956034 +7614 2129 6 0 -25.578511 10.750973 19.368175 +7615 2129 4 0 -25.759953 9.955006 18.909465 +7616 2129 4 0 -26.373616 10.876703 19.816004 +7617 2130 6 0 -15.512850 14.948587 19.552015 +7618 2130 4 0 -14.592416 15.278921 19.862734 +7619 2130 4 0 -15.517720 15.251241 18.670365 +7620 2131 6 0 -22.108713 15.986768 -19.097538 +7621 2131 4 0 -21.973356 16.492171 -18.298729 +7622 2131 4 0 -22.275608 15.084558 -18.884443 +7623 2132 6 0 -24.432040 1.967038 -20.402572 +7624 2132 4 0 -24.316057 2.005234 -19.442897 +7625 2132 4 0 -23.617246 1.596664 -20.796357 +7626 2133 6 0 0.976021 12.002153 3.317883 +7627 2133 4 0 1.233810 12.944966 3.271665 +7628 2133 4 0 1.053167 11.659322 4.215764 +7629 2134 6 0 -22.848328 -11.507211 20.792792 +7630 2134 4 0 -22.031691 -11.288244 20.331458 +7631 2134 4 0 -23.563342 -11.121670 20.237130 +7632 2135 6 0 5.372331 -6.390447 8.998397 +7633 2135 4 0 5.156327 -6.136745 8.105017 +7634 2135 4 0 4.867716 -7.183706 9.243399 +7635 2136 6 0 -5.077546 13.038740 -9.712665 +7636 2136 4 0 -4.384730 12.918197 -10.436683 +7637 2136 4 0 -5.739596 12.361322 -9.833579 +7638 2137 6 0 4.313864 -17.817036 1.578679 +7639 2137 4 0 3.642179 -17.175797 1.786403 +7640 2137 4 0 4.014882 -18.443226 0.872394 +7641 2138 6 0 -10.825600 -3.788470 12.345548 +7642 2138 4 0 -11.474785 -4.350281 12.848087 +7643 2138 4 0 -11.121245 -2.913918 12.572141 +7644 2139 6 0 -10.308333 17.332588 -19.108687 +7645 2139 4 0 -9.699779 18.058376 -18.760246 +7646 2139 4 0 -9.696827 16.600840 -19.450737 +7647 2140 6 0 20.367843 11.704165 19.663819 +7648 2140 4 0 19.894726 12.360595 20.126357 +7649 2140 4 0 20.501092 12.010854 18.743343 +7650 2141 6 0 4.454769 15.397642 -5.721382 +7651 2141 4 0 5.096605 14.668068 -5.812036 +7652 2141 4 0 3.560506 15.012254 -5.700523 +7653 2142 6 0 -10.186828 -2.388640 -11.736429 +7654 2142 4 0 -10.325119 -2.558008 -12.705589 +7655 2142 4 0 -10.806607 -2.883931 -11.193573 +7656 2143 6 0 -24.912356 3.520925 11.318625 +7657 2143 4 0 -24.410292 4.337248 11.078911 +7658 2143 4 0 -25.009199 2.856626 10.581227 +7659 2144 6 0 25.624082 -17.044203 16.133293 +7660 2144 4 0 26.569447 -17.105418 15.881796 +7661 2144 4 0 25.526730 -16.778186 17.038064 +7662 2145 6 0 -18.172292 -12.061346 20.656118 +7663 2145 4 0 -19.064000 -11.714052 20.415716 +7664 2145 4 0 -18.318393 -12.531580 21.542312 +7665 2146 6 0 -2.771360 17.065768 -3.605776 +7666 2146 4 0 -3.498372 16.467521 -3.261648 +7667 2146 4 0 -3.165333 17.613939 -4.263088 +7668 2147 6 0 3.828793 -18.285133 -12.035298 +7669 2147 4 0 4.572657 -18.613626 -12.559285 +7670 2147 4 0 4.121067 -17.462806 -11.547371 +7671 2148 6 0 6.372209 19.895468 -0.828574 +7672 2148 4 0 6.671245 19.260688 -0.181419 +7673 2148 4 0 6.498252 20.741942 -0.410853 +7674 2149 6 0 -26.077165 -2.986273 -6.579517 +7675 2149 4 0 -26.530567 -3.662357 -7.045915 +7676 2149 4 0 -25.278966 -3.412687 -6.199533 +7677 2150 6 0 1.066751 -11.604098 -7.437054 +7678 2150 4 0 0.780778 -12.103600 -8.170135 +7679 2150 4 0 0.490797 -10.859423 -7.390052 +7680 2151 6 0 26.435886 -19.880105 20.436273 +7681 2151 4 0 27.363986 -19.578464 20.393790 +7682 2151 4 0 25.964716 -19.053915 20.333618 +7683 2152 6 0 3.948373 18.634138 -19.227666 +7684 2152 4 0 4.776804 18.681442 -18.670875 +7685 2152 4 0 3.724437 19.545742 -19.268399 +7686 2153 6 0 6.895853 -2.593776 -14.926776 +7687 2153 4 0 6.939228 -1.872325 -14.297950 +7688 2153 4 0 5.922138 -2.668665 -14.881269 +7689 2154 6 0 -11.002838 -0.157918 -15.377800 +7690 2154 4 0 -11.039095 0.271800 -14.533222 +7691 2154 4 0 -11.858546 -0.101002 -15.791180 +7692 2155 6 0 -23.278682 -12.335400 16.986956 +7693 2155 4 0 -23.969958 -13.046960 17.013455 +7694 2155 4 0 -23.739191 -11.494386 17.223424 +7695 2156 6 0 -8.733901 10.961189 15.538536 +7696 2156 4 0 -9.664866 10.721280 15.448379 +7697 2156 4 0 -8.333145 10.082375 15.772687 +7698 2157 6 0 -18.407350 15.043497 -16.093194 +7699 2157 4 0 -17.602548 15.511802 -15.718946 +7700 2157 4 0 -18.860502 14.688871 -15.320254 +7701 2158 6 0 -7.717846 -19.245322 6.135762 +7702 2158 4 0 -8.369623 -18.587554 5.773934 +7703 2158 4 0 -8.005786 -19.439467 7.014406 +7704 2159 6 0 27.537835 -2.244938 17.802365 +7705 2159 4 0 26.595262 -2.186775 17.618048 +7706 2159 4 0 27.566413 -2.809518 18.555718 +7707 2160 6 0 14.035672 -13.942494 -5.025234 +7708 2160 4 0 13.436663 -14.726681 -5.087496 +7709 2160 4 0 14.937241 -14.361386 -5.014306 +7710 2161 6 0 -21.221588 13.030355 13.864922 +7711 2161 4 0 -20.364838 12.937985 13.362956 +7712 2161 4 0 -21.556169 12.132892 13.747752 +7713 2162 6 0 3.382602 17.477038 1.971338 +7714 2162 4 0 2.998725 16.711070 1.403757 +7715 2162 4 0 3.440438 18.202483 1.331855 +7716 2163 6 0 -27.449290 2.763472 -5.473864 +7717 2163 4 0 -26.862644 2.952928 -6.231930 +7718 2163 4 0 -28.220354 2.416823 -5.903707 +7719 2164 6 0 21.309171 1.208177 18.719816 +7720 2164 4 0 20.908787 2.039246 18.612886 +7721 2164 4 0 21.184556 0.863131 19.641302 +7722 2165 6 0 11.888692 16.675087 -12.603821 +7723 2165 4 0 10.999248 16.541633 -13.021832 +7724 2165 4 0 11.878107 16.199062 -11.723643 +7725 2166 6 0 15.960563 -12.459489 -12.277920 +7726 2166 4 0 16.878686 -12.644050 -12.500987 +7727 2166 4 0 16.057647 -11.602612 -11.757235 +7728 2167 6 0 -12.060427 7.034589 4.513332 +7729 2167 4 0 -11.557894 7.520852 3.823017 +7730 2167 4 0 -11.343768 6.740188 5.138402 +7731 2168 6 0 -8.561873 -15.574827 18.511819 +7732 2168 4 0 -8.355748 -14.726119 18.975068 +7733 2168 4 0 -9.321577 -15.327632 17.928691 +7734 2169 6 0 26.839386 -9.977418 -11.801214 +7735 2169 4 0 27.210714 -10.886833 -12.066458 +7736 2169 4 0 26.680237 -9.508287 -12.672668 +7737 2170 6 0 19.487816 -4.295750 -10.653772 +7738 2170 4 0 19.155987 -5.040203 -11.186489 +7739 2170 4 0 19.101905 -4.274245 -9.721574 +7740 2171 6 0 -2.617367 -9.196096 12.807798 +7741 2171 4 0 -3.053330 -8.849761 12.003083 +7742 2171 4 0 -1.757135 -8.732443 12.734709 +7743 2172 6 0 6.741614 9.283527 -17.879312 +7744 2172 4 0 6.380288 9.612761 -18.710343 +7745 2172 4 0 6.169408 8.510946 -17.615438 +7746 2173 6 0 -15.244518 -2.348788 -16.411194 +7747 2173 4 0 -15.286492 -3.293206 -16.627416 +7748 2173 4 0 -16.141604 -2.133344 -16.101761 +7749 2174 6 0 24.076224 14.005333 -20.764432 +7750 2174 4 0 23.579840 13.567519 -20.086274 +7751 2174 4 0 24.304722 13.264661 -21.387917 +7752 2175 6 0 5.197586 -0.122428 -17.048391 +7753 2175 4 0 5.961074 0.070496 -16.498322 +7754 2175 4 0 4.803638 0.707910 -17.262899 +7755 2176 6 0 -12.626531 20.869184 -20.635254 +7756 2176 4 0 -12.565754 20.478495 -19.764243 +7757 2176 4 0 -13.248230 21.560435 -20.592028 +7758 2177 6 0 -6.742302 15.365874 -8.317692 +7759 2177 4 0 -6.373557 14.699314 -8.910768 +7760 2177 4 0 -7.355781 15.918239 -8.809096 +7761 2178 6 0 -8.968953 -3.618531 16.586721 +7762 2178 4 0 -8.318587 -4.203738 17.052583 +7763 2178 4 0 -8.772937 -2.703569 16.930654 +7764 2179 6 0 4.646490 -13.425952 -20.543948 +7765 2179 4 0 5.006101 -13.053008 -19.771175 +7766 2179 4 0 4.114028 -14.244399 -20.306406 +7767 2180 6 0 20.560148 15.165785 18.388964 +7768 2180 4 0 20.026901 15.914780 18.133927 +7769 2180 4 0 20.137478 14.695974 19.131845 +7770 2181 6 0 16.253616 13.647989 17.466410 +7771 2181 4 0 16.144396 14.607506 17.611846 +7772 2181 4 0 15.603177 13.394335 16.728326 +7773 2182 6 0 -2.493112 -10.958918 18.158226 +7774 2182 4 0 -2.871350 -10.325469 17.572446 +7775 2182 4 0 -3.230138 -11.343072 18.670608 +7776 2183 6 0 24.417011 1.731847 15.781773 +7777 2183 4 0 24.256339 1.199810 16.598463 +7778 2183 4 0 24.103762 2.612690 16.033534 +7779 2184 6 0 23.869641 5.093835 -10.829152 +7780 2184 4 0 23.849127 5.899360 -10.350720 +7781 2184 4 0 24.806312 4.827153 -11.005653 +7782 2185 6 0 -25.326011 -10.985445 0.393748 +7783 2185 4 0 -24.487021 -11.323998 0.018652 +7784 2185 4 0 -25.846018 -10.577330 -0.299092 +7785 2186 6 0 -22.140365 -4.015548 -19.394205 +7786 2186 4 0 -21.298001 -3.731962 -19.753685 +7787 2186 4 0 -22.037014 -3.787820 -18.464135 +7788 2187 6 0 16.480100 17.378886 -8.149325 +7789 2187 4 0 15.944629 17.865308 -8.816984 +7790 2187 4 0 17.136048 16.933781 -8.707099 +7791 2188 6 0 9.225758 13.395457 -14.366037 +7792 2188 4 0 8.369757 13.485099 -14.794251 +7793 2188 4 0 9.149310 12.977217 -13.491919 +7794 2189 6 0 -11.512364 7.735604 17.233390 +7795 2189 4 0 -11.580776 7.745448 18.221759 +7796 2189 4 0 -10.572713 7.856344 17.057877 +7797 2190 6 0 22.313965 -17.567699 -18.743216 +7798 2190 4 0 22.795472 -18.390700 -18.665650 +7799 2190 4 0 21.527641 -17.771604 -19.283408 +7800 2191 6 0 26.008630 -8.991349 -9.190478 +7801 2191 4 0 26.251546 -9.200527 -10.105321 +7802 2191 4 0 25.207812 -9.493737 -9.000776 +7803 2192 6 0 16.930474 19.046264 7.447647 +7804 2192 4 0 16.385483 19.298108 8.210284 +7805 2192 4 0 17.081495 19.851182 6.876771 +7806 2193 6 0 -6.878192 14.458044 -14.342832 +7807 2193 4 0 -6.947724 15.178650 -14.986529 +7808 2193 4 0 -6.902494 14.876539 -13.459345 +7809 2194 6 0 -2.603745 -0.170130 11.118461 +7810 2194 4 0 -2.603735 0.193993 10.245898 +7811 2194 4 0 -2.301286 0.557857 11.700540 +7812 2195 6 0 -18.658918 6.935889 12.709416 +7813 2195 4 0 -18.611105 7.903442 12.826990 +7814 2195 4 0 -17.731206 6.682204 12.672567 +7815 2196 6 0 8.242150 20.321564 16.671943 +7816 2196 4 0 8.085884 19.395160 16.403784 +7817 2196 4 0 9.204603 20.443804 16.719883 +7818 2197 6 0 -26.194647 -1.598660 12.827976 +7819 2197 4 0 -25.470850 -1.539447 12.228660 +7820 2197 4 0 -26.434617 -2.532329 12.905279 +7821 2198 6 0 18.147255 11.834318 16.939503 +7822 2198 4 0 17.684791 12.638752 17.229443 +7823 2198 4 0 19.094703 11.992223 16.922098 +7824 2199 6 0 -24.103113 17.414200 -20.406032 +7825 2199 4 0 -24.841847 16.822155 -20.721607 +7826 2199 4 0 -23.364705 16.873068 -20.183752 +7827 2200 6 0 -20.188758 19.419367 -3.947439 +7828 2200 4 0 -20.092108 20.138589 -4.627770 +7829 2200 4 0 -20.779520 18.760391 -4.305720 +7830 2201 6 0 -19.169152 16.892293 -12.706791 +7831 2201 4 0 -18.376967 16.525250 -12.263419 +7832 2201 4 0 -19.451828 16.244073 -13.317784 +7833 2202 6 0 3.042793 -9.624584 6.339287 +7834 2202 4 0 2.126469 -9.764000 6.059404 +7835 2202 4 0 3.422607 -10.448883 6.082030 +7836 2203 6 0 26.796575 -0.250362 10.146355 +7837 2203 4 0 27.695465 -0.487351 9.790163 +7838 2203 4 0 26.991766 0.015930 11.058370 +7839 2204 6 0 -2.724018 -17.347993 -17.041468 +7840 2204 4 0 -3.685391 -17.148462 -17.004347 +7841 2204 4 0 -2.333214 -17.040061 -16.217705 +7842 2205 6 0 22.693834 -19.258880 -8.334918 +7843 2205 4 0 23.207274 -18.747223 -7.672504 +7844 2205 4 0 21.922700 -19.482635 -7.787257 +7845 2206 6 0 10.650819 14.245326 -8.863815 +7846 2206 4 0 10.590380 14.958254 -9.492462 +7847 2206 4 0 9.797431 14.052470 -8.521894 +7848 2207 6 0 21.896317 10.846424 11.520743 +7849 2207 4 0 22.820423 10.614982 11.723752 +7850 2207 4 0 21.512259 10.848333 12.397036 +7851 2208 6 0 -16.629808 6.024934 -16.061930 +7852 2208 4 0 -16.979035 6.163556 -15.154311 +7853 2208 4 0 -16.556800 6.853702 -16.565081 +7854 2209 6 0 -24.056464 -15.267357 -3.334116 +7855 2209 4 0 -24.017471 -15.426759 -2.411717 +7856 2209 4 0 -23.826595 -16.112409 -3.791556 +7857 2210 6 0 -24.814205 14.617559 -6.421721 +7858 2210 4 0 -24.613019 15.462145 -6.916680 +7859 2210 4 0 -25.784459 14.689331 -6.455648 +7860 2211 6 0 12.539335 -4.690091 16.952299 +7861 2211 4 0 12.874872 -3.959104 17.433778 +7862 2211 4 0 13.165313 -5.396450 16.984519 +7863 2212 6 0 27.426473 -20.349285 -4.187459 +7864 2212 4 0 26.932613 -20.185019 -4.988935 +7865 2212 4 0 27.020619 -19.915963 -3.444392 +7866 2213 6 0 -25.378069 18.390923 12.676602 +7867 2213 4 0 -25.468295 18.108442 13.617931 +7868 2213 4 0 -26.284264 18.454249 12.373374 +7869 2214 6 0 2.358488 15.655904 0.172343 +7870 2214 4 0 1.576275 15.538047 -0.330180 +7871 2214 4 0 2.949284 15.115348 -0.279388 +7872 2215 6 0 17.823860 -16.181961 4.219054 +7873 2215 4 0 16.871832 -16.285669 3.895196 +7874 2215 4 0 18.296855 -16.171292 3.367102 +7875 2216 6 0 -13.185175 11.185524 20.273552 +7876 2216 4 0 -12.491020 11.326572 19.606343 +7877 2216 4 0 -14.008783 11.327741 19.799749 +7878 2217 6 0 -16.946375 18.382248 -17.880917 +7879 2217 4 0 -16.601871 19.114714 -17.373712 +7880 2217 4 0 -17.112525 18.719683 -18.756566 +7881 2218 6 0 4.139489 13.924517 -8.158999 +7882 2218 4 0 3.276763 13.674016 -7.871220 +7883 2218 4 0 4.619548 13.009700 -8.222873 +7884 2219 6 0 19.195530 19.194186 -15.410073 +7885 2219 4 0 19.530087 20.044690 -15.698710 +7886 2219 4 0 18.880211 18.717599 -16.173654 +7887 2220 6 0 22.465366 -15.697985 -16.572314 +7888 2220 4 0 22.341005 -16.447983 -17.175221 +7889 2220 4 0 23.268415 -15.298896 -16.787665 +7890 2221 6 0 -6.168779 -9.840021 -9.350190 +7891 2221 4 0 -6.138060 -10.776075 -9.519650 +7892 2221 4 0 -5.375773 -9.424169 -9.650695 +7893 2222 6 0 25.209173 18.017697 -14.898072 +7894 2222 4 0 24.521605 17.467415 -14.490123 +7895 2222 4 0 25.669461 17.420196 -15.513375 +7896 2223 6 0 1.750289 -0.354167 -16.972701 +7897 2223 4 0 1.941430 -1.107141 -17.603779 +7898 2223 4 0 1.332140 0.330238 -17.528621 +7899 2224 6 0 18.682749 11.765475 10.852294 +7900 2224 4 0 19.563556 11.904202 10.494828 +7901 2224 4 0 18.677947 10.845188 11.223074 +7902 2225 6 0 -9.368425 16.562190 4.853452 +7903 2225 4 0 -8.407375 16.292116 4.842479 +7904 2225 4 0 -9.332928 17.502581 4.563723 +7905 2226 6 0 -14.320728 -5.516222 -17.892457 +7906 2226 4 0 -14.106677 -5.147397 -18.800379 +7907 2226 4 0 -14.225038 -6.471192 -17.943054 +7908 2227 6 0 -22.779663 -5.587037 4.961004 +7909 2227 4 0 -23.387774 -5.905882 4.279957 +7910 2227 4 0 -22.003636 -6.116854 4.731429 +7911 2228 6 0 1.608693 14.675487 10.806060 +7912 2228 4 0 2.333564 15.322059 10.910925 +7913 2228 4 0 1.191042 14.647480 11.723121 +7914 2229 6 0 -19.989851 14.272748 -13.831000 +7915 2229 4 0 -20.108765 14.145345 -12.856725 +7916 2229 4 0 -20.810178 14.265544 -14.251075 +7917 2230 6 0 -0.277500 6.116052 -20.054497 +7918 2230 4 0 -1.205482 6.025573 -19.750342 +7919 2230 4 0 0.030270 6.890733 -19.590961 +7920 2231 6 0 -23.218686 16.925049 -14.531729 +7921 2231 4 0 -24.154801 17.137589 -14.620012 +7922 2231 4 0 -22.798436 17.177619 -15.342960 +7923 2232 6 0 14.465041 -13.890297 11.092988 +7924 2232 4 0 14.125737 -13.087596 11.450092 +7925 2232 4 0 14.769204 -13.729760 10.198115 +7926 2233 6 0 -19.342535 19.484499 18.315509 +7927 2233 4 0 -18.817282 19.354539 19.111327 +7928 2233 4 0 -19.942353 18.726732 18.320837 +7929 2234 6 0 0.909574 12.732606 15.451247 +7930 2234 4 0 0.713888 11.749814 15.284439 +7931 2234 4 0 1.425345 12.740199 16.283139 +7932 2235 6 0 -2.274926 14.829696 20.985211 +7933 2235 4 0 -2.781123 13.962453 20.790809 +7934 2235 4 0 -2.630126 15.421882 20.359114 +7935 2236 6 0 7.507399 6.793027 13.609399 +7936 2236 4 0 7.518937 7.728154 13.813229 +7937 2236 4 0 8.443553 6.424691 13.587889 +7938 2237 6 0 12.870660 -12.764019 -10.964166 +7939 2237 4 0 12.942835 -13.465015 -11.598871 +7940 2237 4 0 13.227628 -13.197338 -10.244586 +7941 2238 6 0 8.913179 -11.919018 -6.239675 +7942 2238 4 0 8.887002 -11.850316 -5.252925 +7943 2238 4 0 8.813455 -11.004941 -6.499380 +7944 2239 6 0 -25.746417 7.206326 5.578919 +7945 2239 4 0 -25.082293 6.620904 5.823246 +7946 2239 4 0 -26.564541 6.922453 6.051858 +7947 2240 6 0 25.894755 9.257899 3.861774 +7948 2240 4 0 26.648604 8.789353 3.465470 +7949 2240 4 0 25.145952 8.756940 3.475241 +7950 2241 6 0 -8.830905 19.535286 -18.058852 +7951 2241 4 0 -7.932809 19.419232 -17.567730 +7952 2241 4 0 -8.446850 19.854198 -18.903385 +7953 2242 6 0 18.592621 -6.587479 -13.125998 +7954 2242 4 0 18.627063 -5.766281 -13.617980 +7955 2242 4 0 19.549944 -6.934441 -13.170231 +7956 2243 6 0 -27.003747 -19.268722 -9.708049 +7957 2243 4 0 -26.900925 -18.931745 -10.609127 +7958 2243 4 0 -27.848600 -18.948692 -9.403186 +7959 2244 6 0 25.990256 18.432601 -19.230300 +7960 2244 4 0 26.786890 18.827306 -19.540837 +7961 2244 4 0 25.720829 18.921009 -18.426769 +7962 2245 6 0 -23.820277 -18.817979 -12.740742 +7963 2245 4 0 -23.782285 -19.769046 -12.956748 +7964 2245 4 0 -23.248364 -18.334977 -13.329239 +7965 2246 6 0 -18.359691 4.931419 0.480080 +7966 2246 4 0 -18.326292 5.822977 0.895967 +7967 2246 4 0 -17.534355 4.919940 -0.130658 +7968 2247 6 0 -18.507249 20.994985 10.044481 +7969 2247 4 0 -18.547987 20.135365 9.607738 +7970 2247 4 0 -19.101082 20.989892 10.808237 +7971 2248 6 0 -4.383167 -16.727404 18.388451 +7972 2248 4 0 -5.073507 -17.158665 17.848255 +7973 2248 4 0 -3.547429 -16.962110 18.031186 +7974 2249 6 0 -4.804252 -2.255440 12.424858 +7975 2249 4 0 -5.246469 -3.100345 12.658891 +7976 2249 4 0 -3.913941 -2.453866 12.205563 +7977 2250 6 0 -24.450781 12.411164 4.813077 +7978 2250 4 0 -24.979534 11.582140 4.901976 +7979 2250 4 0 -24.028938 12.289668 3.990280 +7980 2251 6 0 -26.039273 15.478503 -20.033643 +7981 2251 4 0 -25.787380 14.593225 -19.599455 +7982 2251 4 0 -26.775794 15.819420 -19.491089 +7983 2252 6 0 14.062056 9.563642 16.993740 +7984 2252 4 0 14.763770 8.911350 17.143673 +7985 2252 4 0 14.500104 10.412012 17.077299 +7986 2253 6 0 4.484184 -11.730676 11.850201 +7987 2253 4 0 4.881439 -12.103947 12.684819 +7988 2253 4 0 3.547835 -11.668873 12.049225 +7989 2254 6 0 -14.097503 8.062860 -18.256877 +7990 2254 4 0 -14.097091 8.286015 -19.217701 +7991 2254 4 0 -14.272348 7.101844 -18.168430 +7992 2255 6 0 -1.242617 -6.859800 16.709128 +7993 2255 4 0 -1.538903 -6.069642 17.158826 +7994 2255 4 0 -0.956774 -6.520222 15.820973 +7995 2256 6 0 -1.281101 10.186382 20.363478 +7996 2256 4 0 -1.124991 9.953584 19.434999 +7997 2256 4 0 -1.916024 10.917360 20.415283 +7998 2257 6 0 4.583247 -14.837260 7.792526 +7999 2257 4 0 5.277242 -15.516956 7.802532 +8000 2257 4 0 3.716772 -15.158571 7.921129 +8001 2258 6 0 -4.482585 -19.369183 -19.767924 +8002 2258 4 0 -4.741173 -18.669761 -19.147665 +8003 2258 4 0 -4.193943 -19.053555 -20.619737 +8004 2259 6 0 7.047318 -14.707276 -20.284385 +8005 2259 4 0 6.703500 -15.207330 -19.488017 +8006 2259 4 0 6.190142 -14.503563 -20.700524 +8007 2260 6 0 23.833142 -6.861157 16.589067 +8008 2260 4 0 24.695476 -7.170817 16.950692 +8009 2260 4 0 23.677150 -7.301955 15.784807 +8010 2261 6 0 5.995679 -17.998909 3.914141 +8011 2261 4 0 5.476318 -17.882781 3.080567 +8012 2261 4 0 5.412579 -18.346872 4.640099 +8013 2262 6 0 -16.261535 -16.837503 19.128385 +8014 2262 4 0 -16.159495 -17.582113 18.531735 +8015 2262 4 0 -16.037295 -17.072210 20.047591 +8016 2263 6 0 12.975391 18.290335 10.617581 +8017 2263 4 0 12.118949 18.283115 10.175431 +8018 2263 4 0 12.802601 18.580055 11.511186 +8019 2264 6 0 -16.943334 -0.673380 -20.801827 +8020 2264 4 0 -17.817924 -1.087446 -20.715945 +8021 2264 4 0 -17.115465 0.133442 -21.270654 +8022 2265 6 0 6.976699 -19.049773 17.844693 +8023 2265 4 0 7.570702 -18.339339 17.660197 +8024 2265 4 0 7.315559 -19.860252 17.427987 +8025 2266 6 0 24.109467 19.393222 12.331621 +8026 2266 4 0 23.874527 19.733950 13.195341 +8027 2266 4 0 23.847585 18.486492 12.389872 +8028 2267 6 0 -10.766788 -13.469242 4.827464 +8029 2267 4 0 -10.709694 -13.795601 3.910452 +8030 2267 4 0 -10.845380 -12.510608 4.689270 +8031 2268 6 0 23.311349 8.299149 -20.488106 +8032 2268 4 0 22.936005 9.229209 -20.435353 +8033 2268 4 0 23.101181 8.056904 -21.396526 +8034 2269 6 0 14.346382 2.187727 18.536242 +8035 2269 4 0 14.267850 1.244178 18.689768 +8036 2269 4 0 15.244469 2.406046 18.304739 +8037 2270 6 0 -26.947566 -9.971921 -7.791553 +8038 2270 4 0 -26.523003 -9.588995 -7.018587 +8039 2270 4 0 -27.719947 -9.398867 -7.926452 +8040 2271 6 0 -1.645004 -17.217466 18.281848 +8041 2271 4 0 -1.503441 -17.212547 17.328466 +8042 2271 4 0 -1.259441 -16.407871 18.526419 +8043 2272 6 0 -18.185068 -13.481465 -18.963605 +8044 2272 4 0 -18.306998 -12.962840 -18.154768 +8045 2272 4 0 -18.826126 -14.192063 -18.983318 +8046 2273 6 0 21.894032 -11.323972 -14.426640 +8047 2273 4 0 22.165764 -10.897898 -13.607124 +8048 2273 4 0 22.549926 -11.213429 -15.092175 +8049 2274 6 0 10.286552 3.282899 -14.672865 +8050 2274 4 0 10.156644 2.736482 -13.881860 +8051 2274 4 0 9.503828 3.794923 -14.925645 +8052 2275 6 0 -17.275465 -16.899995 -12.204316 +8053 2275 4 0 -16.650047 -17.347498 -12.847925 +8054 2275 4 0 -17.728716 -17.694142 -11.839955 +8055 2276 6 0 9.132713 -17.465568 14.475104 +8056 2276 4 0 9.109121 -16.931937 13.716053 +8057 2276 4 0 8.685477 -18.260615 14.298118 +8058 2277 6 0 -2.219003 -10.437316 7.385585 +8059 2277 4 0 -2.683869 -9.726981 6.932036 +8060 2277 4 0 -2.863656 -10.910261 7.899378 +8061 2278 6 0 21.328627 5.452241 -5.411722 +8062 2278 4 0 20.702591 5.402774 -4.696060 +8063 2278 4 0 21.847512 4.616832 -5.258353 +8064 2279 6 0 25.174339 -4.700786 4.319189 +8065 2279 4 0 25.475426 -5.192515 3.516499 +8066 2279 4 0 24.849082 -5.290270 5.019481 +8067 2280 6 0 -20.973509 17.475850 18.235841 +8068 2280 4 0 -20.795645 16.959839 19.077904 +8069 2280 4 0 -21.937194 17.741268 18.405829 +8070 2281 6 0 -17.032214 -4.404070 -16.615581 +8071 2281 4 0 -18.027750 -4.237947 -16.713048 +8072 2281 4 0 -16.825738 -5.153522 -17.221012 +8073 2282 6 0 5.077355 4.864838 15.841740 +8074 2282 4 0 5.888380 4.293000 15.916342 +8075 2282 4 0 5.502771 5.719564 15.999661 +8076 2283 6 0 14.150746 7.193364 7.768856 +8077 2283 4 0 13.512887 7.556242 8.342946 +8078 2283 4 0 13.719519 6.964481 6.933299 +8079 2284 6 0 24.979967 10.864144 -3.827107 +8080 2284 4 0 25.315666 11.790605 -3.820018 +8081 2284 4 0 24.586117 10.647324 -4.635764 +8082 2285 6 0 -19.307013 7.977617 -19.097895 +8083 2285 4 0 -18.730894 8.713079 -18.873103 +8084 2285 4 0 -19.574094 8.132279 -20.016040 +8085 2286 6 0 24.806727 -12.761480 -19.492468 +8086 2286 4 0 24.884669 -13.553250 -18.933552 +8087 2286 4 0 23.868023 -12.741257 -19.679606 +8088 2287 6 0 -16.494024 -10.263681 -3.455262 +8089 2287 4 0 -16.433900 -9.520847 -4.087773 +8090 2287 4 0 -16.512097 -9.942519 -2.552121 +8091 2288 6 0 7.239107 -8.678420 15.402099 +8092 2288 4 0 8.128327 -8.620090 15.837696 +8093 2288 4 0 7.413730 -9.358400 14.729775 +8094 2289 6 0 -11.637039 -18.299602 1.445919 +8095 2289 4 0 -11.805502 -17.472273 0.974361 +8096 2289 4 0 -10.835652 -18.063314 1.950128 +8097 2290 6 0 3.539913 -9.008378 14.869684 +8098 2290 4 0 3.690725 -8.667083 13.987735 +8099 2290 4 0 3.786240 -8.275061 15.438308 +8100 2291 6 0 25.309639 -20.139973 8.261630 +8101 2291 4 0 26.025004 -20.789387 8.243372 +8102 2291 4 0 24.785538 -20.229959 9.088332 +8103 2292 6 0 -11.167618 15.368263 17.768795 +8104 2292 4 0 -11.447760 15.042536 16.890680 +8105 2292 4 0 -10.221576 15.243374 17.719247 +8106 2293 6 0 15.783799 16.252451 16.657327 +8107 2293 4 0 16.469650 16.826129 16.279349 +8108 2293 4 0 15.146657 16.166099 16.010457 +8109 2294 6 0 -23.087822 12.851874 11.524125 +8110 2294 4 0 -22.550515 13.272517 12.247361 +8111 2294 4 0 -23.433828 13.646077 11.045696 +8112 2295 6 0 18.224787 5.336233 10.181216 +8113 2295 4 0 17.768669 5.758936 9.423686 +8114 2295 4 0 17.527118 5.295554 10.828797 +8115 2296 6 0 23.091715 -2.832106 10.928215 +8116 2296 4 0 23.963022 -3.221214 10.847174 +8117 2296 4 0 23.111421 -1.957098 10.500452 +8118 2297 6 0 -8.122293 -8.153763 8.762475 +8119 2297 4 0 -8.486311 -7.377176 8.275878 +8120 2297 4 0 -7.842547 -7.967759 9.693098 +8121 2298 6 0 -23.746981 -1.978340 20.222446 +8122 2298 4 0 -24.119623 -2.610408 19.587105 +8123 2298 4 0 -22.788269 -2.052555 20.075719 +8124 2299 6 0 15.889034 -8.818090 19.786354 +8125 2299 4 0 16.162821 -8.087882 19.189549 +8126 2299 4 0 16.517604 -9.567302 19.583898 +8127 2300 6 0 -22.434542 -1.993577 2.665229 +8128 2300 4 0 -21.639169 -2.320398 3.125908 +8129 2300 4 0 -22.887302 -1.544538 3.368374 +8130 2301 6 0 -4.294135 12.198286 3.905187 +8131 2301 4 0 -3.524217 12.481373 3.400532 +8132 2301 4 0 -4.358032 12.831366 4.583192 +8133 2302 6 0 -10.287802 2.763656 12.120543 +8134 2302 4 0 -10.140580 1.873404 11.826731 +8135 2302 4 0 -10.262187 2.731368 13.100818 +8136 2303 6 0 11.514142 11.933521 -10.265166 +8137 2303 4 0 11.257715 12.740478 -9.772518 +8138 2303 4 0 11.449563 11.209135 -9.611780 +8139 2304 6 0 4.752686 10.041816 10.494911 +8140 2304 4 0 5.000099 10.228340 11.405783 +8141 2304 4 0 4.465587 10.901799 10.118351 +8142 2305 6 0 17.099352 -16.900118 20.580015 +8143 2305 4 0 16.248341 -17.056394 20.914403 +8144 2305 4 0 16.964732 -16.230792 19.853524 +8145 2306 6 0 -6.880763 4.754709 14.803663 +8146 2306 4 0 -7.780049 5.017298 14.837120 +8147 2306 4 0 -6.602000 5.380408 14.109963 +8148 2307 6 0 18.852257 3.117416 3.416315 +8149 2307 4 0 18.466519 2.248205 3.599368 +8150 2307 4 0 19.770424 2.988919 3.600584 +8151 2308 6 0 -19.565302 -15.452338 -12.857316 +8152 2308 4 0 -19.465174 -14.703294 -13.434992 +8153 2308 4 0 -18.713185 -15.861077 -12.849765 +8154 2309 6 0 -22.600437 -10.691469 12.850297 +8155 2309 4 0 -23.397550 -10.659087 13.302216 +8156 2309 4 0 -22.787116 -11.067370 12.012734 +8157 2310 6 0 -21.982415 -13.573385 -4.311729 +8158 2310 4 0 -22.884778 -13.924822 -4.053153 +8159 2310 4 0 -21.591210 -13.340585 -3.436663 +8160 2311 6 0 -9.482768 -17.119153 10.316888 +8161 2311 4 0 -10.089752 -16.593034 9.704444 +8162 2311 4 0 -9.402425 -17.912940 9.854825 +8163 2312 6 0 14.779023 -10.205617 3.169184 +8164 2312 4 0 14.033719 -9.624095 2.903870 +8165 2312 4 0 14.431082 -10.650018 3.996000 +8166 2313 6 0 -23.065785 7.688851 4.302863 +8167 2313 4 0 -23.519497 6.846326 4.179947 +8168 2313 4 0 -23.396856 8.243234 3.642471 +8169 2314 6 0 -12.420110 17.313613 -9.713155 +8170 2314 4 0 -13.364634 17.232909 -9.649724 +8171 2314 4 0 -12.198343 18.200726 -10.087577 +8172 2315 6 0 13.807063 -18.735375 -18.358481 +8173 2315 4 0 13.518261 -18.146104 -17.665040 +8174 2315 4 0 14.609291 -19.207101 -18.003404 +8175 2316 6 0 10.712591 7.098327 3.970951 +8176 2316 4 0 10.424496 6.939336 4.829144 +8177 2316 4 0 10.486897 6.231102 3.501449 +8178 2317 6 0 -26.193278 8.679696 17.901485 +8179 2317 4 0 -25.410504 8.357458 17.457879 +8180 2317 4 0 -26.819464 8.901614 17.137834 +8181 2318 6 0 19.451507 -12.567707 -15.280479 +8182 2318 4 0 19.003766 -12.254527 -14.428024 +8183 2318 4 0 20.294592 -12.135913 -15.254851 +8184 2319 6 0 -14.332854 -0.923507 14.572189 +8185 2319 4 0 -14.044747 -0.194105 14.037975 +8186 2319 4 0 -13.492568 -1.193300 14.988120 +8187 2320 6 0 -8.730522 14.085678 -10.180676 +8188 2320 4 0 -8.524068 13.138626 -10.211460 +8189 2320 4 0 -9.480763 14.191583 -10.748692 +8190 2321 6 0 -18.278878 -5.590157 8.386336 +8191 2321 4 0 -18.405152 -4.662040 8.661744 +8192 2321 4 0 -17.563780 -5.717750 9.039776 +8193 2322 6 0 -24.210906 -9.471833 -3.828648 +8194 2322 4 0 -23.595084 -9.970587 -4.330527 +8195 2322 4 0 -23.577826 -8.951405 -3.327851 +8196 2323 6 0 -7.110604 8.838398 10.174602 +8197 2323 4 0 -7.782545 9.119070 9.563121 +8198 2323 4 0 -6.874836 7.936950 10.110612 +8199 2324 6 0 24.419141 17.000522 -10.922840 +8200 2324 4 0 23.664703 16.933938 -11.553390 +8201 2324 4 0 24.021846 17.152778 -10.052143 +8202 2325 6 0 -14.488243 5.098469 4.479912 +8203 2325 4 0 -13.709956 5.650481 4.473177 +8204 2325 4 0 -14.910202 5.058380 3.581039 +8205 2326 6 0 -2.415807 -13.812743 6.907700 +8206 2326 4 0 -2.596718 -13.309899 6.111317 +8207 2326 4 0 -3.251745 -14.327682 7.109165 +8208 2327 6 0 -18.926033 -9.523396 -18.297588 +8209 2327 4 0 -18.539154 -9.705366 -19.167443 +8210 2327 4 0 -19.196583 -8.616444 -18.314206 +8211 2328 6 0 23.648770 -10.033565 -19.143545 +8212 2328 4 0 23.763359 -9.374241 -19.822180 +8213 2328 4 0 24.359914 -10.609348 -19.397407 +8214 2329 6 0 0.735457 -17.444252 -0.196869 +8215 2329 4 0 1.204966 -17.103235 -0.982724 +8216 2329 4 0 -0.166461 -17.675326 -0.501142 +8217 2330 6 0 15.977053 8.980217 19.819118 +8218 2330 4 0 15.510910 8.262919 19.411773 +8219 2330 4 0 15.638831 9.774710 19.469638 +8220 2331 6 0 -21.818391 12.562887 20.032627 +8221 2331 4 0 -22.085628 11.618258 19.842948 +8222 2331 4 0 -20.827992 12.718524 19.975012 +8223 2332 6 0 7.039712 -16.964990 -15.541675 +8224 2332 4 0 6.809451 -17.534371 -14.799854 +8225 2332 4 0 7.846558 -16.584905 -15.213738 +8226 2333 6 0 -10.516103 -19.359216 -4.984483 +8227 2333 4 0 -11.487322 -19.499249 -4.976576 +8228 2333 4 0 -10.316797 -19.130113 -5.876399 +8229 2334 6 0 -15.712544 -18.195821 -16.791463 +8230 2334 4 0 -15.386725 -17.379305 -16.972966 +8231 2334 4 0 -16.234052 -18.450302 -17.577749 +8232 2335 6 0 20.375630 2.207122 -4.920313 +8233 2335 4 0 20.216775 1.456591 -4.343459 +8234 2335 4 0 20.280207 1.853389 -5.797632 +8235 2336 6 0 22.857055 19.552693 3.665905 +8236 2336 4 0 22.878248 19.783393 4.649190 +8237 2336 4 0 23.742572 19.802123 3.384761 +8238 2337 6 0 -23.291098 12.571857 -7.317143 +8239 2337 4 0 -23.912608 13.233941 -6.880268 +8240 2337 4 0 -22.652186 12.332429 -6.543330 +8241 2338 6 0 12.984606 10.221427 -16.808099 +8242 2338 4 0 13.667678 9.959368 -16.244780 +8243 2338 4 0 12.511584 9.401797 -16.883576 +8244 2339 6 0 27.270245 0.587979 13.208753 +8245 2339 4 0 27.702404 -0.278797 13.294250 +8246 2339 4 0 26.279511 0.464606 13.258979 +8247 2340 6 0 5.657499 -16.976293 13.990530 +8248 2340 4 0 4.705984 -16.954734 13.883042 +8249 2340 4 0 5.909722 -16.502798 14.791441 +8250 2341 6 0 22.979947 17.951763 0.527007 +8251 2341 4 0 22.428004 18.639190 0.176667 +8252 2341 4 0 22.281623 17.341478 0.914453 +8253 2342 6 0 -21.891524 -16.491873 5.462047 +8254 2342 4 0 -21.611111 -15.606060 5.550776 +8255 2342 4 0 -22.025511 -16.701806 4.529568 +8256 2343 6 0 8.528721 7.946876 17.483315 +8257 2343 4 0 9.390982 8.385502 17.311853 +8258 2343 4 0 8.485801 7.948173 18.426233 +8259 2344 6 0 26.823691 0.686378 2.887481 +8260 2344 4 0 26.841167 0.391628 3.805678 +8261 2344 4 0 26.597454 1.662650 2.917193 +8262 2345 6 0 -4.950286 -7.194323 15.626699 +8263 2345 4 0 -4.352839 -6.657887 15.072055 +8264 2345 4 0 -5.857741 -7.272638 15.219003 +8265 2346 6 0 -8.714977 5.000352 11.128210 +8266 2346 4 0 -9.170865 4.207326 11.391243 +8267 2346 4 0 -8.026665 4.716136 10.523111 +8268 2347 6 0 -21.206733 -3.279994 -6.524932 +8269 2347 4 0 -20.929590 -2.947470 -5.608742 +8270 2347 4 0 -21.369929 -2.564467 -7.124044 +8271 2348 6 0 -24.169876 -16.066494 -0.699927 +8272 2348 4 0 -23.893194 -16.983386 -0.501792 +8273 2348 4 0 -23.818535 -15.566437 0.016995 +8274 2349 6 0 -4.762418 0.978128 -17.450230 +8275 2349 4 0 -5.459419 0.534407 -17.851461 +8276 2349 4 0 -3.876584 0.532188 -17.586085 +8277 2350 6 0 -23.690384 0.720873 19.030161 +8278 2350 4 0 -24.529537 0.743437 18.583662 +8279 2350 4 0 -23.655688 -0.011267 19.593259 +8280 2351 6 0 -15.912159 -12.362138 19.142289 +8281 2351 4 0 -16.860673 -12.328378 19.455109 +8282 2351 4 0 -15.543971 -13.259386 19.298591 +8283 2352 6 0 21.658993 17.599149 -16.014662 +8284 2352 4 0 22.041785 18.520354 -15.943036 +8285 2352 4 0 20.778035 17.749200 -16.427622 +8286 2353 6 0 -19.912308 -13.107035 -14.484614 +8287 2353 4 0 -19.659870 -12.430860 -13.832450 +8288 2353 4 0 -19.896529 -12.695904 -15.325705 +8289 2354 6 0 -24.276277 -16.465070 11.658834 +8290 2354 4 0 -24.414709 -16.008322 12.561598 +8291 2354 4 0 -24.456920 -15.764788 11.022016 +8292 2355 6 0 7.338121 15.134359 12.353797 +8293 2355 4 0 6.756929 14.359360 12.209000 +8294 2355 4 0 7.312954 15.621960 11.560650 +8295 2356 6 0 16.833359 -15.091185 7.049718 +8296 2356 4 0 17.575828 -15.201998 7.598156 +8297 2356 4 0 17.181929 -14.913423 6.159696 +8298 2357 6 0 -25.459827 -8.831619 -10.909942 +8299 2357 4 0 -26.346699 -9.154571 -11.164077 +8300 2357 4 0 -25.113612 -9.635356 -10.548749 +8301 2358 6 0 14.104756 2.118788 -11.000106 +8302 2358 4 0 14.145828 1.958779 -9.996196 +8303 2358 4 0 13.664160 1.315915 -11.343904 +8304 2359 6 0 15.657145 -19.646810 2.896166 +8305 2359 4 0 16.434824 -20.115913 3.051182 +8306 2359 4 0 15.028606 -20.220332 2.452201 +8307 2360 6 0 23.725885 -12.794695 -0.945499 +8308 2360 4 0 23.281780 -11.890719 -0.926868 +8309 2360 4 0 24.708749 -12.621299 -0.988388 +8310 2361 6 0 -16.865263 14.164216 13.710722 +8311 2361 4 0 -17.362193 13.380801 13.838272 +8312 2361 4 0 -16.087062 13.922374 13.209541 +8313 2362 6 0 -19.739666 -15.403180 15.520974 +8314 2362 4 0 -20.455057 -15.397351 14.881774 +8315 2362 4 0 -20.082522 -14.871806 16.282279 +8316 2363 6 0 19.096837 -7.172079 16.486018 +8317 2363 4 0 19.407501 -6.257692 16.370379 +8318 2363 4 0 19.040095 -7.459208 15.607247 +8319 2364 6 0 18.172332 -12.158590 -6.201699 +8320 2364 4 0 18.304057 -11.335714 -6.732706 +8321 2364 4 0 19.035089 -12.338188 -5.764950 +8322 2365 6 0 -0.868698 -19.642469 -16.996885 +8323 2365 4 0 -1.363468 -20.113317 -17.713302 +8324 2365 4 0 -1.471726 -19.010491 -16.662422 +8325 2366 6 0 -24.645397 10.341459 -7.907386 +8326 2366 4 0 -25.403222 10.434913 -7.336084 +8327 2366 4 0 -24.138877 11.164300 -7.816681 +8328 2367 6 0 -16.672238 -8.013464 18.598945 +8329 2367 4 0 -16.066967 -8.743970 18.706313 +8330 2367 4 0 -16.176282 -7.259661 18.335226 +8331 2368 6 0 22.487322 14.165266 -7.478753 +8332 2368 4 0 22.557098 13.462620 -8.195467 +8333 2368 4 0 23.077183 13.896514 -6.804199 +8334 2369 6 0 -16.969008 0.617904 2.364611 +8335 2369 4 0 -17.366120 1.196458 3.012496 +8336 2369 4 0 -16.204897 0.132723 2.713670 +8337 2370 6 0 -16.105014 -0.776954 10.291984 +8338 2370 4 0 -16.257341 0.223589 10.333435 +8339 2370 4 0 -16.822249 -1.143779 10.739482 +8340 2371 6 0 -1.572980 -19.983373 -2.947973 +8341 2371 4 0 -1.992560 -20.034455 -3.807433 +8342 2371 4 0 -0.620010 -19.746082 -3.116100 +8343 2372 6 0 -14.996679 12.712532 -5.614114 +8344 2372 4 0 -15.916609 12.454215 -5.655277 +8345 2372 4 0 -14.599913 12.087283 -6.181656 +8346 2373 6 0 -6.550042 17.243085 -1.311911 +8347 2373 4 0 -7.370137 17.795578 -1.470109 +8348 2373 4 0 -6.675338 16.814239 -0.435288 +8349 2374 6 0 -22.961585 9.343900 -1.894881 +8350 2374 4 0 -22.135413 9.413165 -2.387021 +8351 2374 4 0 -23.019360 8.393337 -1.628379 +8352 2375 6 0 -23.240008 -19.417092 6.368497 +8353 2375 4 0 -23.612098 -20.201035 6.825569 +8354 2375 4 0 -23.684109 -18.690648 6.877699 +8355 2376 6 0 -3.975590 2.585287 -20.330975 +8356 2376 4 0 -3.555653 1.727030 -20.090182 +8357 2376 4 0 -3.232879 3.201768 -20.459323 +8358 2377 6 0 13.624748 -19.863473 12.144241 +8359 2377 4 0 14.457772 -19.530528 12.546517 +8360 2377 4 0 12.915028 -19.260602 12.383266 +8361 2378 6 0 23.620886 -17.871879 14.645268 +8362 2378 4 0 24.200914 -17.421417 15.259794 +8363 2378 4 0 23.549736 -17.298378 13.830439 +8364 2379 6 0 9.321358 4.851563 -10.671349 +8365 2379 4 0 8.417643 4.825903 -10.980879 +8366 2379 4 0 9.236659 5.389642 -9.880988 +8367 2380 6 0 16.676932 -15.595371 18.042582 +8368 2380 4 0 15.776328 -15.312249 17.740520 +8369 2380 4 0 17.268778 -14.856833 17.976717 +8370 2381 6 0 5.120016 13.517889 11.545409 +8371 2381 4 0 4.343182 13.415911 12.098245 +8372 2381 4 0 4.693345 13.853732 10.680472 +8373 2382 6 0 -25.377039 -18.256471 8.076220 +8374 2382 4 0 -25.781276 -18.544454 8.897977 +8375 2382 4 0 -25.633977 -17.323858 7.972468 +8376 2383 6 0 0.809058 7.564416 -14.066874 +8377 2383 4 0 0.916059 7.331613 -13.143223 +8378 2383 4 0 1.470333 8.274989 -14.200531 +8379 2384 6 0 15.418267 9.781452 0.490529 +8380 2384 4 0 16.087047 9.430117 -0.107289 +8381 2384 4 0 15.469266 9.208927 1.264230 +8382 2385 6 0 18.819099 0.059487 -7.791298 +8383 2385 4 0 18.409799 -0.334456 -8.599701 +8384 2385 4 0 18.505418 0.975155 -7.815461 +8385 2386 6 0 18.734857 -11.129665 -12.743525 +8386 2386 4 0 19.553404 -11.223386 -12.120138 +8387 2386 4 0 18.518443 -10.240054 -12.855533 +8388 2387 6 0 -6.542631 16.490309 -5.774007 +8389 2387 4 0 -7.424909 16.908246 -5.691889 +8390 2387 4 0 -6.518994 16.127379 -6.676862 +8391 2388 6 0 -11.192140 0.472205 -12.639446 +8392 2388 4 0 -12.103697 0.267919 -12.529950 +8393 2388 4 0 -10.710800 -0.374282 -12.557572 +8394 2389 6 0 16.720488 13.886958 -20.533060 +8395 2389 4 0 16.205223 14.702224 -20.376437 +8396 2389 4 0 16.691127 13.403715 -19.702754 +8397 2390 6 0 17.388334 13.435587 -15.657568 +8398 2390 4 0 18.130270 13.582226 -16.327461 +8399 2390 4 0 17.639406 12.621568 -15.195169 +8400 2391 6 0 -6.834253 10.232886 -18.214238 +8401 2391 4 0 -6.903061 10.582756 -17.312839 +8402 2391 4 0 -7.065760 10.977380 -18.753726 +8403 2392 6 0 -26.724908 17.912645 17.886470 +8404 2392 4 0 -25.957218 18.458136 17.628812 +8405 2392 4 0 -26.362765 17.099535 18.218344 +8406 2393 6 0 -0.903403 -3.732795 -18.221524 +8407 2393 4 0 0.015845 -3.986413 -18.434069 +8408 2393 4 0 -1.449749 -4.292278 -18.787390 +8409 2394 6 0 8.478846 18.397280 11.407292 +8410 2394 4 0 7.633351 18.651942 11.041557 +8411 2394 4 0 9.129265 18.582960 10.779627 +8412 2395 6 0 -9.044898 12.879599 11.037060 +8413 2395 4 0 -8.299458 12.613036 10.480728 +8414 2395 4 0 -9.785562 12.774996 10.383091 +8415 2396 6 0 16.212680 8.794036 14.029672 +8416 2396 4 0 15.473945 9.288728 13.836685 +8417 2396 4 0 17.028607 9.276518 14.011973 +8418 2397 6 0 -12.268552 13.361223 -20.521861 +8419 2397 4 0 -13.186409 13.158881 -20.579852 +8420 2397 4 0 -12.306685 14.297827 -20.782380 +8421 2398 6 0 21.001802 -1.484392 16.467423 +8422 2398 4 0 20.737187 -1.861020 17.327615 +8423 2398 4 0 21.860569 -1.911455 16.193850 +8424 2399 6 0 -9.356304 11.431280 -8.974418 +8425 2399 4 0 -8.659737 10.769575 -8.653703 +8426 2399 4 0 -9.803431 11.675976 -8.182315 +8427 2400 6 0 26.948445 8.871461 -17.613543 +8428 2400 4 0 27.531052 9.681414 -17.576254 +8429 2400 4 0 27.482335 8.261182 -17.042391 +8430 2401 6 0 18.976966 2.434133 -12.543728 +8431 2401 4 0 18.194377 2.424795 -11.982928 +8432 2401 4 0 19.117316 3.368724 -12.808991 +8433 2402 6 0 8.245403 -12.742057 19.723005 +8434 2402 4 0 8.144484 -13.022949 20.662655 +8435 2402 4 0 7.837153 -13.446042 19.196869 +8436 2403 6 0 9.039756 -7.597109 18.653269 +8437 2403 4 0 8.770812 -7.616934 19.576989 +8438 2403 4 0 9.066589 -6.664479 18.418706 +8439 2404 6 0 10.189217 11.926636 11.235547 +8440 2404 4 0 10.233257 12.873995 11.065027 +8441 2404 4 0 9.236322 11.798256 11.121031 +8442 2405 6 0 -19.235380 -20.224186 -5.743147 +8443 2405 4 0 -19.963520 -19.550478 -5.766714 +8444 2405 4 0 -18.597575 -19.892671 -5.077870 +8445 2406 6 0 17.081164 12.504780 -5.519702 +8446 2406 4 0 17.317528 12.830762 -4.628825 +8447 2406 4 0 17.566228 11.707478 -5.694496 +8448 2407 6 0 -17.833354 13.022736 -7.625662 +8449 2407 4 0 -18.435075 12.266236 -7.562794 +8450 2407 4 0 -17.596760 13.126821 -6.753333 +8451 2408 6 0 -16.003848 -12.359888 13.230149 +8452 2408 4 0 -16.195567 -13.201470 12.841886 +8453 2408 4 0 -16.339851 -12.416796 14.117412 +8454 2409 6 0 0.176516 -12.560501 -12.425472 +8455 2409 4 0 0.737394 -13.294947 -12.707192 +8456 2409 4 0 -0.008554 -11.988851 -13.210535 +8457 2410 6 0 15.945838 0.256833 12.759642 +8458 2410 4 0 15.315992 0.578271 12.079867 +8459 2410 4 0 15.303877 -0.130234 13.393857 +8460 2411 6 0 3.991270 11.948196 8.788506 +8461 2411 4 0 4.354131 11.617913 7.978688 +8462 2411 4 0 3.989725 12.878797 8.755522 +8463 2412 6 0 24.041021 -18.227784 19.978317 +8464 2412 4 0 23.613150 -19.023367 19.715938 +8465 2412 4 0 23.421760 -17.634320 20.391706 +8466 2413 6 0 4.480569 2.293232 -17.929461 +8467 2413 4 0 4.737918 2.408019 -18.806644 +8468 2413 4 0 3.697109 2.859289 -17.719771 +8469 2414 6 0 -21.893430 -14.247042 -8.071389 +8470 2414 4 0 -21.621325 -13.340615 -8.179140 +8471 2414 4 0 -21.245096 -14.771492 -7.611926 +8472 2415 6 0 11.391170 -20.197067 6.087190 +8473 2415 4 0 12.332346 -20.225253 6.056925 +8474 2415 4 0 11.169435 -19.741912 5.268989 +8475 2416 6 0 -17.767521 13.536365 -18.283934 +8476 2416 4 0 -17.676219 14.086222 -17.468766 +8477 2416 4 0 -17.016627 12.978563 -18.394451 +8478 2417 6 0 5.005032 -20.873389 -8.545316 +8479 2417 4 0 4.212566 -20.486316 -8.983260 +8480 2417 4 0 4.690972 -21.402526 -7.849785 +8481 2418 6 0 18.199775 -4.330757 -14.972084 +8482 2418 4 0 17.789625 -3.483346 -14.772916 +8483 2418 4 0 18.849294 -4.135351 -15.681645 +8484 2419 6 0 19.744670 16.153747 4.684702 +8485 2419 4 0 18.926975 15.872879 5.113981 +8486 2419 4 0 20.486481 15.836577 5.222155 +8487 2420 6 0 -0.915970 -9.397508 15.585411 +8488 2420 4 0 -0.105843 -9.703483 16.010408 +8489 2420 4 0 -1.285330 -8.812368 16.200287 +8490 2421 6 0 -23.858596 3.816844 -5.177897 +8491 2421 4 0 -23.879687 4.029482 -4.237763 +8492 2421 4 0 -24.276504 2.954820 -5.342696 +8493 2422 6 0 11.838596 14.359137 5.947499 +8494 2422 4 0 11.923450 13.438110 5.725008 +8495 2422 4 0 12.426438 14.419837 6.789373 +8496 2423 6 0 -24.516087 -8.212903 6.467548 +8497 2423 4 0 -24.905939 -8.825058 7.092971 +8498 2423 4 0 -23.896260 -8.737352 6.010203 +8499 2424 6 0 12.794509 0.536645 -20.243875 +8500 2424 4 0 12.046024 0.975194 -20.739130 +8501 2424 4 0 12.750658 0.998686 -19.404096 +8502 2425 6 0 -2.221545 7.221132 -15.714309 +8503 2425 4 0 -1.564134 7.922819 -15.440249 +8504 2425 4 0 -1.907716 6.786282 -16.499729 +8505 2426 6 0 -15.262103 -1.025135 3.744497 +8506 2426 4 0 -15.665604 -1.870757 3.765630 +8507 2426 4 0 -15.328619 -0.606155 4.583614 +8508 2427 6 0 20.108494 -9.991193 -19.911625 +8509 2427 4 0 19.428700 -9.825766 -19.213627 +8510 2427 4 0 20.361712 -9.133136 -20.249113 +8511 2428 6 0 12.867409 -6.904802 4.443594 +8512 2428 4 0 12.264306 -6.203776 4.409753 +8513 2428 4 0 13.784027 -6.565705 4.350727 +8514 2429 6 0 24.058876 -8.248822 -17.051222 +8515 2429 4 0 23.730319 -9.008822 -17.519701 +8516 2429 4 0 24.878618 -8.026208 -17.519719 +8517 2430 6 0 -14.847363 -1.001783 -19.170682 +8518 2430 4 0 -15.449801 -0.826718 -19.858698 +8519 2430 4 0 -15.320403 -1.330455 -18.387373 +8520 2431 6 0 15.553192 2.814264 -3.465226 +8521 2431 4 0 14.896744 3.481739 -3.135135 +8522 2431 4 0 16.160657 3.336721 -3.991437 +8523 2432 6 0 -13.974002 9.185648 16.956055 +8524 2432 4 0 -13.130305 8.696408 16.805351 +8525 2432 4 0 -14.376866 8.733537 17.688722 +8526 2433 6 0 -11.797740 -0.516894 9.586967 +8527 2433 4 0 -12.628798 -0.925501 9.242559 +8528 2433 4 0 -11.646717 0.185675 8.970795 +8529 2434 6 0 24.903028 -3.994226 -11.118622 +8530 2434 4 0 23.952025 -4.106045 -10.736954 +8531 2434 4 0 24.790476 -3.484811 -11.918719 +8532 2435 6 0 2.220549 5.328975 16.431794 +8533 2435 4 0 1.808604 4.568086 16.851941 +8534 2435 4 0 3.174924 5.179737 16.323538 +8535 2436 6 0 1.396616 14.937103 19.138615 +8536 2436 4 0 0.558182 14.600636 18.844822 +8537 2436 4 0 1.257435 14.884393 20.102246 +8538 2437 6 0 -20.671636 -15.366474 -18.208204 +8539 2437 4 0 -21.380399 -15.277369 -18.859413 +8540 2437 4 0 -20.736983 -16.181001 -17.742657 +8541 2438 6 0 -13.058044 -20.095582 -4.362430 +8542 2438 4 0 -13.024712 -20.612656 -3.543798 +8543 2438 4 0 -13.691481 -19.389144 -4.075579 +8544 2439 6 0 -15.561123 -4.237765 12.636329 +8545 2439 4 0 -16.268647 -3.833291 13.167415 +8546 2439 4 0 -15.110937 -3.419743 12.299589 +8547 2440 6 0 -24.759181 -6.035582 2.884287 +8548 2440 4 0 -25.250513 -6.831996 2.887098 +8549 2440 4 0 -25.305365 -5.369041 2.551951 +8550 2441 6 0 -4.620853 12.299627 11.037908 +8551 2441 4 0 -4.440765 13.138122 11.409774 +8552 2441 4 0 -4.916886 11.692935 11.716163 +8553 2442 6 0 -16.569703 1.526861 -7.254759 +8554 2442 4 0 -16.695783 1.936301 -8.074606 +8555 2442 4 0 -16.882141 0.632206 -7.402201 +8556 2443 6 0 23.467888 -9.654261 -12.695108 +8557 2443 4 0 24.029597 -9.067666 -13.167615 +8558 2443 4 0 23.123232 -9.217050 -11.833851 +8559 2444 6 0 -18.429010 -3.061156 8.894173 +8560 2444 4 0 -19.027972 -2.389846 8.642550 +8561 2444 4 0 -18.106797 -2.785618 9.787642 +8562 2445 6 0 -19.107978 15.849121 -9.475466 +8563 2445 4 0 -18.864733 15.428418 -8.655322 +8564 2445 4 0 -18.505127 16.629956 -9.591908 +8565 2446 6 0 22.274682 -20.084251 -0.325198 +8566 2446 4 0 22.135094 -19.096797 -0.356152 +8567 2446 4 0 23.083213 -20.126631 -0.830959 +8568 2447 6 0 24.369325 -3.216706 -4.897640 +8569 2447 4 0 25.222404 -2.719894 -4.895318 +8570 2447 4 0 24.445157 -3.895914 -4.229474 +8571 2448 6 0 -9.139981 -19.842644 16.043544 +8572 2448 4 0 -8.820691 -19.672535 15.122253 +8573 2448 4 0 -9.672340 -20.660357 15.944536 +8574 2449 6 0 -20.896241 -15.764905 -2.307185 +8575 2449 4 0 -21.812479 -15.705631 -2.446120 +8576 2449 4 0 -20.844603 -15.784793 -1.327016 +8577 2450 6 0 7.223156 -5.748983 -18.629737 +8578 2450 4 0 7.206095 -4.844227 -18.946828 +8579 2450 4 0 7.989785 -5.796585 -18.164482 +8580 2451 6 0 -25.843140 -1.143611 9.149078 +8581 2451 4 0 -25.886005 -1.657786 8.289135 +8582 2451 4 0 -25.272098 -1.801443 9.596520 +8583 2452 6 0 -25.617505 11.234770 1.302402 +8584 2452 4 0 -26.519698 11.382080 0.891273 +8585 2452 4 0 -25.709717 11.496799 2.260967 +8586 2453 6 0 -24.008718 3.700426 14.077463 +8587 2453 4 0 -23.636744 2.818441 14.397144 +8588 2453 4 0 -24.193959 3.715212 13.098008 +8589 2454 6 0 -25.288161 15.287096 -3.633466 +8590 2454 4 0 -24.701801 15.181375 -2.917528 +8591 2454 4 0 -24.884059 15.980496 -4.222265 +8592 2455 6 0 -18.371976 0.316233 -12.753606 +8593 2455 4 0 -17.540257 0.805382 -12.677195 +8594 2455 4 0 -18.928928 0.935156 -13.269213 +8595 2456 6 0 -7.333443 0.117823 -18.660950 +8596 2456 4 0 -8.021021 0.414744 -18.077567 +8597 2456 4 0 -7.588161 -0.774648 -18.860400 +8598 2457 6 0 7.916046 -4.737118 -11.962175 +8599 2457 4 0 7.823803 -4.591176 -10.961540 +8600 2457 4 0 8.487079 -3.962811 -12.242330 +8601 2458 6 0 -16.065017 -17.683748 12.637430 +8602 2458 4 0 -17.011987 -17.735296 12.722608 +8603 2458 4 0 -15.831448 -18.384474 11.953837 +8604 2459 6 0 21.305339 -15.655490 -5.124093 +8605 2459 4 0 20.807407 -16.186834 -5.710639 +8606 2459 4 0 21.624819 -16.214868 -4.447516 +8607 2460 6 0 -26.764181 -18.581640 -16.921151 +8608 2460 4 0 -26.740653 -17.883931 -16.251171 +8609 2460 4 0 -25.889831 -19.016845 -16.852743 +8610 2461 6 0 -16.578359 -2.340901 14.589648 +8611 2461 4 0 -16.492161 -3.040832 15.326073 +8612 2461 4 0 -15.697628 -1.820257 14.616293 +8613 2462 6 0 26.043166 5.997514 -3.795215 +8614 2462 4 0 26.451990 6.864435 -3.803447 +8615 2462 4 0 26.795850 5.513156 -3.370169 +8616 2463 6 0 -2.866251 17.249672 -19.402655 +8617 2463 4 0 -2.050135 17.665045 -19.652864 +8618 2463 4 0 -2.832242 16.313071 -19.542218 +8619 2464 6 0 -15.459807 -11.710100 -10.460216 +8620 2464 4 0 -14.969300 -11.366276 -9.661631 +8621 2464 4 0 -16.276955 -12.017208 -9.984012 +8622 2465 6 0 19.650264 6.930828 12.762298 +8623 2465 4 0 19.873188 6.462285 13.595929 +8624 2465 4 0 20.303044 6.550090 12.177619 +8625 2466 6 0 -22.570365 -4.412836 -1.811273 +8626 2466 4 0 -22.171357 -5.263031 -1.838077 +8627 2466 4 0 -22.826216 -4.391044 -0.929643 +8628 2467 6 0 -15.225393 0.344956 6.093949 +8629 2467 4 0 -14.897061 1.256657 6.050627 +8630 2467 4 0 -14.862108 -0.118094 6.882677 +8631 2468 6 0 -26.214592 10.149434 -12.755279 +8632 2468 4 0 -27.155901 10.181440 -12.954282 +8633 2468 4 0 -26.080437 9.913123 -11.832638 +8634 2469 6 0 -26.639137 -20.836220 10.642324 +8635 2469 4 0 -26.244776 -19.942202 10.604043 +8636 2469 4 0 -26.010374 -21.363114 10.100802 +8637 2470 6 0 27.068918 -13.224704 20.865450 +8638 2470 4 0 27.744233 -12.679284 21.316162 +8639 2470 4 0 26.232445 -12.945570 21.191563 +8640 2471 6 0 -15.301597 13.975513 -8.460131 +8641 2471 4 0 -14.952706 13.782668 -7.567357 +8642 2471 4 0 -16.244257 13.821878 -8.381549 +8643 2472 6 0 25.467875 11.658105 -7.593959 +8644 2472 4 0 24.761290 11.160502 -7.120317 +8645 2472 4 0 25.002961 12.057880 -8.288551 +8646 2473 6 0 -27.479869 -4.262964 -20.483737 +8647 2473 4 0 -26.752473 -4.746654 -20.858210 +8648 2473 4 0 -27.165915 -3.756567 -19.782830 +8649 2474 6 0 -24.406173 20.048905 -13.265390 +8650 2474 4 0 -23.845919 19.394517 -12.782711 +8651 2474 4 0 -25.326791 19.952777 -13.266139 +8652 2475 6 0 -12.606740 1.855396 14.924299 +8653 2475 4 0 -13.099296 2.292250 15.633985 +8654 2475 4 0 -13.213129 1.841828 14.213081 +8655 2476 6 0 12.163259 12.537713 19.532478 +8656 2476 4 0 12.952113 12.023699 19.336851 +8657 2476 4 0 11.421932 11.885251 19.451751 +8658 2477 6 0 19.216013 1.204159 16.354062 +8659 2477 4 0 19.693651 0.628292 16.987922 +8660 2477 4 0 19.788924 1.982359 16.259421 +8661 2478 6 0 9.476954 16.143883 -14.222672 +8662 2478 4 0 9.874109 15.966920 -15.122506 +8663 2478 4 0 9.278436 15.281894 -13.908079 +8664 2479 6 0 -14.534233 -15.722743 -17.125213 +8665 2479 4 0 -14.612818 -15.234699 -16.271855 +8666 2479 4 0 -14.914996 -15.225762 -17.899753 +8667 2480 6 0 -7.315791 17.649326 18.027047 +8668 2480 4 0 -6.781097 18.032306 18.752166 +8669 2480 4 0 -8.151176 18.220094 17.921736 +8670 2481 6 0 -18.382710 -16.629801 4.193883 +8671 2481 4 0 -18.385951 -16.521263 5.149432 +8672 2481 4 0 -17.627253 -16.147937 3.769420 +8673 2482 6 0 -15.417927 -6.534956 -12.241821 +8674 2482 4 0 -15.990818 -7.277530 -12.157190 +8675 2482 4 0 -15.651097 -5.969923 -11.493776 +8676 2483 6 0 0.402862 14.629930 13.340607 +8677 2483 4 0 -0.252964 15.247709 13.638832 +8678 2483 4 0 0.540834 14.019125 14.040061 +8679 2484 6 0 12.212673 -14.561562 8.432466 +8680 2484 4 0 12.964986 -15.158798 8.469829 +8681 2484 4 0 12.315635 -13.749340 8.974910 +8682 2485 6 0 -18.091351 14.816669 -20.791191 +8683 2485 4 0 -17.950349 14.394028 -19.955312 +8684 2485 4 0 -17.259160 15.337091 -20.997461 +8685 2486 6 0 20.846407 4.941141 -20.805564 +8686 2486 4 0 20.364445 5.609240 -20.314152 +8687 2486 4 0 21.773006 5.036677 -20.468448 +8688 2487 6 0 -18.235581 1.799447 7.616936 +8689 2487 4 0 -18.663035 2.668602 7.871183 +8690 2487 4 0 -18.147248 1.507995 8.534548 +8691 2488 6 0 12.243946 -10.407747 -4.453069 +8692 2488 4 0 12.758610 -10.750408 -5.173538 +8693 2488 4 0 11.391861 -10.887258 -4.514732 +8694 2489 6 0 -15.999205 -0.324038 16.881023 +8695 2489 4 0 -15.685432 -0.202706 15.976630 +8696 2489 4 0 -15.623326 0.405687 17.366937 +8697 2490 6 0 -23.099614 -14.642217 -19.649766 +8698 2490 4 0 -23.777759 -15.309775 -19.518530 +8699 2490 4 0 -23.241127 -14.411915 -20.620505 +8700 2491 6 0 -12.249488 9.185541 -16.320990 +8701 2491 4 0 -12.902804 8.826914 -16.950148 +8702 2491 4 0 -11.588894 9.548457 -16.894605 +8703 2492 6 0 -4.051701 -13.736377 -16.555628 +8704 2492 4 0 -4.494654 -14.354729 -17.129699 +8705 2492 4 0 -4.462835 -13.910768 -15.684946 +8706 2493 6 0 -11.801200 19.657830 -10.999540 +8707 2493 4 0 -10.902720 19.828996 -11.011831 +8708 2493 4 0 -12.193533 20.466103 -10.567549 +8709 2494 6 0 -24.325618 14.045672 -1.110263 +8710 2494 4 0 -24.668600 14.350444 -0.200830 +8711 2494 4 0 -24.816092 13.231043 -1.195474 +8712 2495 6 0 20.913056 15.489658 -18.886527 +8713 2495 4 0 20.368015 16.190531 -18.479805 +8714 2495 4 0 21.821778 15.751011 -18.640831 +8715 2496 6 0 -20.772862 0.764056 -6.084683 +8716 2496 4 0 -20.333324 1.468628 -5.568275 +8717 2496 4 0 -20.870557 -0.044044 -5.434493 +8718 2497 6 0 -16.073764 -5.000219 -5.989733 +8719 2497 4 0 -15.211568 -4.748827 -5.581555 +8720 2497 4 0 -16.376788 -5.851245 -5.640415 +8721 2498 6 0 -9.856355 -16.695376 -19.135619 +8722 2498 4 0 -10.833867 -16.815665 -19.193496 +8723 2498 4 0 -9.591699 -17.153724 -19.905312 +8724 2499 6 0 -14.392982 0.813400 -5.967904 +8725 2499 4 0 -14.439076 -0.104057 -5.900368 +8726 2499 4 0 -15.047260 1.134714 -6.628678 +8727 2500 6 0 11.045455 -13.563452 -6.886523 +8728 2500 4 0 10.981894 -14.173292 -6.136333 +8729 2500 4 0 10.392197 -12.867802 -6.742279 +8730 2501 6 0 20.205100 13.593403 -6.053417 +8731 2501 4 0 19.481313 14.001651 -6.432278 +8732 2501 4 0 20.986779 14.039356 -6.342708 +8733 2502 6 0 -15.365488 5.137757 1.769971 +8734 2502 4 0 -16.164843 4.770892 1.413857 +8735 2502 4 0 -14.688240 4.932112 1.136328 +8736 2503 6 0 -24.720205 -11.036422 -9.472540 +8737 2503 4 0 -25.299911 -10.766165 -8.734947 +8738 2503 4 0 -25.200381 -11.736926 -9.906125 +8739 2504 6 0 14.559792 11.008849 -19.039727 +8740 2504 4 0 15.234376 11.619514 -18.598604 +8741 2504 4 0 13.848001 10.777673 -18.398174 +8742 2505 6 0 20.737940 13.944347 3.008812 +8743 2505 4 0 19.926090 13.665780 2.507060 +8744 2505 4 0 20.524403 14.681916 3.550067 +8745 2506 6 0 -13.687080 4.284684 12.620334 +8746 2506 4 0 -14.374801 3.638577 12.764178 +8747 2506 4 0 -13.341649 4.114854 11.765071 +8748 2507 6 0 10.858099 -17.177182 -20.193932 +8749 2507 4 0 10.006770 -17.050221 -20.711055 +8750 2507 4 0 11.163899 -17.997677 -20.596267 +8751 2508 6 0 -1.413844 20.882523 -7.532723 +8752 2508 4 0 -0.481522 20.795022 -7.591494 +8753 2508 4 0 -1.734791 20.061230 -7.123891 +8754 2509 6 0 14.883760 4.844985 -11.460983 +8755 2509 4 0 14.857826 5.007527 -12.430076 +8756 2509 4 0 14.543696 3.941245 -11.329620 +8757 2510 6 0 -6.076326 -4.794057 13.123230 +8758 2510 4 0 -7.063204 -4.795068 13.194896 +8759 2510 4 0 -5.787599 -5.455376 13.703743 +8760 2511 6 0 26.801734 19.306820 7.537896 +8761 2511 4 0 27.324481 18.524252 7.345834 +8762 2511 4 0 27.305309 20.057747 7.249205 +8763 2512 6 0 17.631040 11.938297 -2.819567 +8764 2512 4 0 18.494147 11.630708 -2.989743 +8765 2512 4 0 17.500906 12.097849 -1.861896 +8766 2513 6 0 -5.066723 14.593124 8.613540 +8767 2513 4 0 -5.776044 13.928470 8.604036 +8768 2513 4 0 -5.472521 15.379622 8.936421 +8769 2514 6 0 -22.625793 -6.943329 -10.402222 +8770 2514 4 0 -22.918006 -7.487802 -11.106371 +8771 2514 4 0 -22.525718 -6.063678 -10.788262 +8772 2515 6 0 11.828624 -19.683428 -20.603919 +8773 2515 4 0 12.217112 -20.243126 -21.346224 +8774 2515 4 0 12.385880 -19.784195 -19.860322 +8775 2516 6 0 -21.139138 9.961065 13.641562 +8776 2516 4 0 -21.977740 9.505083 13.402813 +8777 2516 4 0 -20.669934 9.781538 12.788303 +8778 2517 6 0 25.519216 -5.515401 1.511029 +8779 2517 4 0 26.084211 -5.177738 0.810141 +8780 2517 4 0 24.693318 -5.003524 1.409607 +8781 2518 6 0 26.272080 10.541058 9.764091 +8782 2518 4 0 25.609606 11.193003 9.426754 +8783 2518 4 0 25.839012 9.942262 10.435364 +8784 2519 6 0 25.016001 0.794303 -1.014649 +8785 2519 4 0 25.368203 0.342397 -1.801633 +8786 2519 4 0 25.407512 1.692440 -0.976171 +8787 2520 6 0 -8.746565 3.936264 -17.089748 +8788 2520 4 0 -8.606611 4.042084 -18.035704 +8789 2520 4 0 -8.750589 2.966468 -16.991948 +8790 2521 6 0 21.588920 13.603723 -12.704304 +8791 2521 4 0 21.601929 14.305164 -12.022119 +8792 2521 4 0 21.312576 14.081953 -13.484692 +8793 2522 6 0 -18.216349 -3.529717 0.360926 +8794 2522 4 0 -18.540051 -2.874458 0.978203 +8795 2522 4 0 -18.963370 -4.161327 0.221890 +8796 2523 6 0 19.308604 17.633776 -17.848331 +8797 2523 4 0 18.426310 17.372206 -17.746813 +8798 2523 4 0 19.313729 18.351135 -18.545042 +8799 2524 6 0 23.180289 12.694539 3.506974 +8800 2524 4 0 22.252060 12.962086 3.303073 +8801 2524 4 0 23.366253 11.863114 3.057800 +8802 2525 6 0 -17.100932 8.883526 -6.444854 +8803 2525 4 0 -16.173403 8.831265 -6.716554 +8804 2525 4 0 -17.583234 8.325208 -7.157965 +8805 2526 6 0 14.323717 15.125299 -5.725594 +8806 2526 4 0 15.041767 15.729064 -5.519842 +8807 2526 4 0 13.765048 15.154023 -4.972067 +8808 2527 6 0 -19.909899 0.941274 -8.892043 +8809 2527 4 0 -20.063118 1.882998 -8.670527 +8810 2527 4 0 -20.016683 0.615676 -7.987400 +8811 2528 6 0 -4.062922 0.518298 17.993285 +8812 2528 4 0 -4.234902 1.391334 17.589117 +8813 2528 4 0 -4.820041 -0.077704 17.801729 +8814 2529 6 0 26.232840 -11.346405 0.934374 +8815 2529 4 0 26.965729 -10.796137 1.273638 +8816 2529 4 0 26.535197 -11.828470 0.207089 +8817 2530 6 0 18.568052 -3.606897 4.561302 +8818 2530 4 0 17.633584 -3.536757 4.401867 +8819 2530 4 0 18.956111 -3.197861 3.755933 +8820 2531 6 0 -23.855092 5.074567 4.116598 +8821 2531 4 0 -23.064224 4.611628 4.537652 +8822 2531 4 0 -23.710838 5.025654 3.139103 +8823 2532 6 0 26.437758 -20.018004 1.491909 +8824 2532 4 0 26.350439 -19.182255 1.070486 +8825 2532 4 0 27.361760 -20.307715 1.508970 +8826 2533 6 0 -15.774583 11.702587 -19.124466 +8827 2533 4 0 -15.128134 11.654611 -18.394652 +8828 2533 4 0 -16.197784 10.854994 -19.059229 +8829 2534 6 0 13.604852 -5.588538 -11.240265 +8830 2534 4 0 13.941716 -4.779794 -10.783187 +8831 2534 4 0 13.492173 -6.306084 -10.658525 +8832 2535 6 0 -4.406927 9.867817 9.346751 +8833 2535 4 0 -5.311013 9.555296 9.655422 +8834 2535 4 0 -4.255731 10.665634 9.843775 +8835 2536 6 0 -5.324087 -1.607821 -19.326145 +8836 2536 4 0 -5.081210 -2.540467 -19.512431 +8837 2536 4 0 -5.681118 -1.658898 -18.424650 +8838 2537 6 0 7.210255 -0.591966 -13.016339 +8839 2537 4 0 7.132769 -0.267418 -12.059025 +8840 2537 4 0 7.145986 0.215754 -13.558300 +8841 2538 6 0 13.031739 18.007964 -16.574884 +8842 2538 4 0 13.701983 18.076453 -17.280260 +8843 2538 4 0 13.560834 18.505150 -15.807835 +8844 2539 6 0 -4.939182 19.582248 2.433779 +8845 2539 4 0 -4.348475 19.232076 1.705221 +8846 2539 4 0 -4.493649 20.306827 2.886563 +8847 2540 6 0 -26.648293 -0.947736 -17.385316 +8848 2540 4 0 -26.109245 -1.287067 -18.123131 +8849 2540 4 0 -27.139044 -0.227784 -17.739830 +8850 2541 6 0 19.417331 5.365442 -12.381828 +8851 2541 4 0 20.057565 6.030330 -12.629842 +8852 2541 4 0 18.801680 5.841907 -11.794057 +8853 2542 6 0 -19.679332 -1.764604 -19.638774 +8854 2542 4 0 -19.289416 -1.940059 -18.795824 +8855 2542 4 0 -19.719754 -0.802184 -19.615952 +8856 2543 6 0 16.188925 -8.137607 9.745803 +8857 2543 4 0 15.895930 -8.655747 9.012990 +8858 2543 4 0 15.671496 -7.334126 9.820282 +8859 2544 6 0 17.367529 -1.265528 20.226689 +8860 2544 4 0 17.209414 -2.128384 20.612209 +8861 2544 4 0 17.475811 -0.580216 20.915152 +8862 2545 6 0 20.517093 9.728672 9.587262 +8863 2545 4 0 21.222551 9.963620 10.212987 +8864 2545 4 0 19.824767 9.384636 10.113042 +8865 2546 6 0 -7.547448 20.192218 -20.533482 +8866 2546 4 0 -6.695025 19.629425 -20.571646 +8867 2546 4 0 -8.008402 20.075383 -21.344144 +8868 2547 6 0 -16.582915 -1.120027 -4.095394 +8869 2547 4 0 -16.849559 -0.208322 -4.049542 +8870 2547 4 0 -16.720426 -1.473779 -3.214581 +8871 2548 6 0 4.785781 1.946407 13.103817 +8872 2548 4 0 4.799308 1.247503 12.424632 +8873 2548 4 0 4.583242 1.575294 13.963927 +8874 2549 6 0 -8.165114 -12.900949 2.168446 +8875 2549 4 0 -8.256829 -12.788477 3.143987 +8876 2549 4 0 -7.320909 -13.341131 2.150781 +8877 2550 6 0 -17.554071 -15.744741 -16.262189 +8878 2550 4 0 -17.806278 -16.375423 -15.592159 +8879 2550 4 0 -18.351583 -15.356631 -16.607464 +8880 2551 6 0 27.326866 4.195826 19.441977 +8881 2551 4 0 28.011431 4.581461 18.842795 +8882 2551 4 0 26.527694 4.615286 19.081611 +8883 2552 6 0 -25.419970 -6.739402 -9.247054 +8884 2552 4 0 -25.459364 -7.498417 -9.890859 +8885 2552 4 0 -24.515740 -6.409622 -9.324420 +8886 2553 6 0 -3.380308 -14.523714 -7.300867 +8887 2553 4 0 -3.061003 -15.308131 -6.909980 +8888 2553 4 0 -2.917512 -14.327994 -8.109098 +8889 2554 6 0 26.207829 15.728093 -19.215945 +8890 2554 4 0 25.966653 16.561497 -19.590938 +8891 2554 4 0 26.062905 14.999376 -19.810656 +8892 2555 6 0 -18.866057 -0.711382 15.470718 +8893 2555 4 0 -19.290122 -1.568096 15.298654 +8894 2555 4 0 -17.951441 -0.972639 15.451259 +8895 2556 6 0 18.465047 8.813449 11.216472 +8896 2556 4 0 18.798663 8.151346 11.818158 +8897 2556 4 0 17.716063 8.381682 10.839333 +8898 2557 6 0 -24.781204 -20.600352 -18.705084 +8899 2557 4 0 -25.022898 -19.710672 -18.985244 +8900 2557 4 0 -25.460136 -21.155945 -19.120654 +8901 2558 6 0 22.729959 2.205214 -7.072615 +8902 2558 4 0 22.357169 1.293535 -7.021078 +8903 2558 4 0 22.701750 2.488699 -7.961356 +8904 2559 6 0 12.690918 2.750591 12.342202 +8905 2559 4 0 12.532985 3.617962 11.878555 +8906 2559 4 0 13.133585 2.199071 11.681589 +8907 2560 6 0 24.106980 -11.846114 14.571893 +8908 2560 4 0 23.699036 -11.148912 15.134462 +8909 2560 4 0 23.233694 -12.194399 14.228632 +8910 2561 6 0 0.015177 -14.005197 -19.056743 +8911 2561 4 0 -0.340775 -13.532157 -18.287023 +8912 2561 4 0 -0.773966 -14.258584 -19.587550 +8913 2562 6 0 12.361724 4.484402 -15.999210 +8914 2562 4 0 12.200963 5.407914 -16.093788 +8915 2562 4 0 11.619804 4.000673 -15.643034 +8916 2563 6 0 -4.332154 14.465183 5.913532 +8917 2563 4 0 -3.550293 15.013973 5.769350 +8918 2563 4 0 -4.511279 14.482735 6.928514 +8919 2564 6 0 -2.423184 -19.036991 20.142811 +8920 2564 4 0 -2.033960 -18.570661 20.871778 +8921 2564 4 0 -2.200093 -18.567230 19.324641 +8922 2565 6 0 -11.400807 16.524027 12.877501 +8923 2565 4 0 -10.684181 16.008719 12.380621 +8924 2565 4 0 -12.191788 16.488834 12.343702 +8925 2566 6 0 15.966093 16.748739 -1.323378 +8926 2566 4 0 16.412638 17.338758 -1.989326 +8927 2566 4 0 15.598457 17.376590 -0.651299 +8928 2567 6 0 23.415752 18.871243 -18.062665 +8929 2567 4 0 23.451778 19.269195 -17.182012 +8930 2567 4 0 22.494121 18.975734 -18.366439 +8931 2568 6 0 -8.572201 3.275476 -10.014766 +8932 2568 4 0 -9.403406 3.269988 -10.503336 +8933 2568 4 0 -8.724278 3.329701 -9.074127 +8934 2569 6 0 -11.585480 -0.851627 12.287499 +8935 2569 4 0 -11.320746 -0.082366 12.769641 +8936 2569 4 0 -11.472816 -0.637183 11.362553 +8937 2570 6 0 7.497602 -9.434427 -12.321588 +8938 2570 4 0 8.071421 -10.126251 -12.076632 +8939 2570 4 0 8.042121 -8.593371 -12.397957 +8940 2571 6 0 4.778213 -10.266015 -19.410251 +8941 2571 4 0 5.274109 -9.668837 -18.817242 +8942 2571 4 0 4.120565 -9.651627 -19.758229 +8943 2572 6 0 -6.111007 -15.043780 2.679188 +8944 2572 4 0 -5.289890 -15.200515 3.239461 +8945 2572 4 0 -6.645239 -15.919834 2.758924 +8946 2573 6 0 -19.627428 -18.648983 -20.285776 +8947 2573 4 0 -18.763886 -19.012576 -20.099994 +8948 2573 4 0 -19.447444 -17.996380 -20.946059 +8949 2574 6 0 9.799336 -4.134177 -14.605227 +8950 2574 4 0 9.726430 -3.298650 -14.107003 +8951 2574 4 0 10.588497 -4.491055 -14.189406 +8952 2575 6 0 6.956853 10.981174 -15.927933 +8953 2575 4 0 6.333575 10.252829 -16.183246 +8954 2575 4 0 7.290948 10.697439 -15.077221 +8955 2576 6 0 15.996505 -7.421222 -2.982722 +8956 2576 4 0 16.037378 -8.363657 -3.163947 +8957 2576 4 0 15.971488 -7.414229 -2.004616 +8958 2577 6 0 24.116659 17.319712 -5.748450 +8959 2577 4 0 24.717303 17.575301 -5.045222 +8960 2577 4 0 24.154648 16.310133 -5.689457 +8961 2578 6 0 -25.014350 19.047244 5.636389 +8962 2578 4 0 -24.831592 18.532801 6.467994 +8963 2578 4 0 -25.569417 19.791621 5.840508 +8964 2579 6 0 -13.760710 14.201790 -16.036971 +8965 2579 4 0 -13.882187 15.099458 -16.440666 +8966 2579 4 0 -13.724599 14.326841 -15.088458 +8967 2580 6 0 -24.389392 17.787413 -4.553817 +8968 2580 4 0 -24.972675 18.418071 -5.068364 +8969 2580 4 0 -24.356964 18.276421 -3.698179 +8970 2581 6 0 -18.723840 -6.150098 -13.057313 +8971 2581 4 0 -18.318192 -6.956567 -12.670367 +8972 2581 4 0 -17.968230 -5.629913 -13.262178 +8973 2582 6 0 0.195836 -4.045493 20.385139 +8974 2582 4 0 0.549498 -4.632208 21.063706 +8975 2582 4 0 -0.603773 -4.486592 20.007533 +8976 2583 6 0 -5.473498 -2.320372 -16.638624 +8977 2583 4 0 -5.812762 -2.143253 -15.717531 +8978 2583 4 0 -5.163919 -3.274843 -16.629360 +8979 2584 6 0 21.657434 10.195244 -12.556194 +8980 2584 4 0 21.466450 11.110479 -12.686972 +8981 2584 4 0 21.662028 10.206355 -11.604800 +8982 2585 6 0 -18.526380 -11.853303 0.119709 +8983 2585 4 0 -18.677742 -12.441590 -0.589422 +8984 2585 4 0 -18.075660 -11.001968 -0.204346 +8985 2586 6 0 -19.755563 -18.537381 -2.766741 +8986 2586 4 0 -19.962233 -18.408807 -3.703137 +8987 2586 4 0 -19.999131 -17.782990 -2.372006 +8988 2587 6 0 25.476128 17.625846 -3.184333 +8989 2587 4 0 26.203145 17.076934 -2.886644 +8990 2587 4 0 25.710710 18.493253 -2.850200 +8991 2588 6 0 -22.305377 1.710018 15.373391 +8992 2588 4 0 -22.044667 1.930929 16.308564 +8993 2588 4 0 -22.836038 0.853232 15.392466 +8994 2589 6 0 2.757401 -15.671844 -1.738405 +8995 2589 4 0 2.387180 -15.115097 -1.096143 +8996 2589 4 0 3.413578 -16.267070 -1.380191 +8997 2590 6 0 25.430670 -2.334847 6.648866 +8998 2590 4 0 25.893201 -2.829135 7.309607 +8999 2590 4 0 24.545839 -2.463509 7.030661 +9000 2591 6 0 3.889750 2.458553 -20.722084 +9001 2591 4 0 3.444777 1.541092 -20.936428 +9002 2591 4 0 3.192280 2.998470 -20.481554 +9003 2592 6 0 19.435277 -5.919201 6.178342 +9004 2592 4 0 18.742497 -6.147165 6.835144 +9005 2592 4 0 19.082846 -5.397301 5.451949 +9006 2593 6 0 -1.325956 10.838557 -7.120140 +9007 2593 4 0 -1.379491 10.683558 -6.153949 +9008 2593 4 0 -1.024828 11.727198 -7.077078 +9009 2594 6 0 -3.710126 14.086716 -7.244913 +9010 2594 4 0 -4.337761 13.541137 -7.799347 +9011 2594 4 0 -4.000550 13.881396 -6.362053 +9012 2595 6 0 14.433778 -1.890208 -13.881242 +9013 2595 4 0 13.768753 -2.557931 -14.088173 +9014 2595 4 0 14.194801 -1.387777 -13.039639 +9015 2596 6 0 -18.934813 -1.053060 1.293190 +9016 2596 4 0 -19.547923 -0.821685 1.967866 +9017 2596 4 0 -18.094001 -0.641682 1.660883 +9018 2597 6 0 -22.405398 -20.039410 9.627718 +9019 2597 4 0 -22.796434 -20.600182 8.972850 +9020 2597 4 0 -22.131968 -19.299630 9.083235 +9021 2598 6 0 -1.229753 11.457428 10.074790 +9022 2598 4 0 -0.334237 11.703470 10.327241 +9023 2598 4 0 -1.157156 10.837370 9.316439 +9024 2599 6 0 25.443002 2.066902 -6.888756 +9025 2599 4 0 25.641541 2.915762 -7.359788 +9026 2599 4 0 24.465208 2.093523 -6.739748 +9027 2600 6 0 -16.581214 16.377510 -14.832297 +9028 2600 4 0 -16.587099 15.904994 -13.968869 +9029 2600 4 0 -16.866698 17.278853 -14.742235 +9030 2601 6 0 11.983368 11.828299 -3.823724 +9031 2601 4 0 12.336985 12.445002 -3.178218 +9032 2601 4 0 11.049304 11.604866 -3.665958 +9033 2602 6 0 21.164572 -1.185333 -16.015117 +9034 2602 4 0 20.715162 -0.431609 -16.354646 +9035 2602 4 0 20.819380 -1.264906 -15.151962 +9036 2603 6 0 5.457366 -10.657358 -13.800772 +9037 2603 4 0 4.779858 -10.165440 -14.279853 +9038 2603 4 0 6.212045 -10.040539 -13.706945 +9039 2604 6 0 -16.423429 10.434483 -15.277807 +9040 2604 4 0 -15.708526 10.928082 -15.699592 +9041 2604 4 0 -15.960741 9.897443 -14.616298 +9042 2605 6 0 -20.419587 -19.665938 5.773644 +9043 2605 4 0 -21.363895 -19.581010 6.013361 +9044 2605 4 0 -19.853905 -19.280863 6.468747 +9045 2606 6 0 19.508036 -18.494331 8.912926 +9046 2606 4 0 19.727428 -18.712582 9.835185 +9047 2606 4 0 19.913134 -19.105692 8.298087 +9048 2607 6 0 19.742354 -2.749373 18.946243 +9049 2607 4 0 20.356111 -2.867791 19.687152 +9050 2607 4 0 19.073759 -2.160527 19.341368 +9051 2608 6 0 19.005725 16.659102 -4.024674 +9052 2608 4 0 18.186097 16.480938 -4.427734 +9053 2608 4 0 18.814608 17.298422 -3.358553 +9054 2609 6 0 -8.835887 18.312505 -7.442487 +9055 2609 4 0 -8.830492 17.732483 -8.193218 +9056 2609 4 0 -9.752425 18.649905 -7.404203 +9057 2610 6 0 -17.336326 4.931650 10.634975 +9058 2610 4 0 -16.450097 5.217439 10.271982 +9059 2610 4 0 -17.882557 4.558518 9.889708 +9060 2611 6 0 -3.010824 -5.905956 6.847801 +9061 2611 4 0 -2.748688 -5.113745 6.359917 +9062 2611 4 0 -2.163371 -6.028171 7.336259 +9063 2612 6 0 26.674110 12.326845 1.003397 +9064 2612 4 0 26.498840 12.357411 1.941376 +9065 2612 4 0 26.095376 11.585032 0.663483 +9066 2613 6 0 -3.647702 -6.137587 13.529843 +9067 2613 4 0 -3.585661 -5.496886 12.804045 +9068 2613 4 0 -3.582668 -6.993279 13.154224 +9069 2614 6 0 1.988731 3.642853 -17.323133 +9070 2614 4 0 1.657523 3.030179 -16.746788 +9071 2614 4 0 1.714357 4.548463 -17.022125 +9072 2615 6 0 -21.467906 15.279507 16.450567 +9073 2615 4 0 -21.342432 15.396388 15.459294 +9074 2615 4 0 -21.255917 16.108495 16.873553 +9075 2616 6 0 10.722659 -15.332451 -4.565762 +9076 2616 4 0 10.219128 -14.832093 -3.873147 +9077 2616 4 0 11.478425 -15.649236 -4.183169 +9078 2617 6 0 -15.362943 8.381189 -9.911049 +9079 2617 4 0 -15.790421 8.852870 -9.163602 +9080 2617 4 0 -15.901457 8.456340 -10.687883 +9081 2618 6 0 -6.117005 -17.666075 11.598739 +9082 2618 4 0 -5.807530 -18.593273 11.402299 +9083 2618 4 0 -5.391363 -17.258909 12.082625 +9084 2619 6 0 15.809786 8.519937 -19.377408 +9085 2619 4 0 15.758815 8.522648 -20.341707 +9086 2619 4 0 15.420577 9.368007 -19.123689 +9087 2620 6 0 16.939240 -18.373645 7.950825 +9088 2620 4 0 17.207858 -18.006941 7.092997 +9089 2620 4 0 17.812610 -18.447723 8.295733 +9090 2621 6 0 -12.507522 -15.054493 6.331021 +9091 2621 4 0 -13.226017 -14.420799 6.460827 +9092 2621 4 0 -11.849976 -14.561229 5.786593 +9093 2622 6 0 -18.182152 4.799952 -11.866172 +9094 2622 4 0 -18.038039 4.897463 -10.917789 +9095 2622 4 0 -18.695958 4.021311 -12.029165 +9096 2623 6 0 -9.377203 11.614184 3.311631 +9097 2623 4 0 -9.092786 10.701027 3.311174 +9098 2623 4 0 -8.739940 12.083447 3.909937 +9099 2624 6 0 24.894256 -5.525807 -20.636863 +9100 2624 4 0 24.507335 -5.547278 -19.753182 +9101 2624 4 0 25.790020 -5.247577 -20.418409 +9102 2625 6 0 -23.172834 -17.188227 2.440789 +9103 2625 4 0 -23.395171 -18.018880 2.825747 +9104 2625 4 0 -22.193387 -17.125237 2.517058 +9105 2626 6 0 24.135008 -19.930490 -4.684991 +9106 2626 4 0 24.122289 -18.925946 -4.803857 +9107 2626 4 0 24.712920 -20.215229 -5.372877 +9108 2627 6 0 -17.792076 11.534192 15.059996 +9109 2627 4 0 -16.965370 11.797213 15.470927 +9110 2627 4 0 -18.560988 11.913780 15.443831 +9111 2628 6 0 -18.514941 20.339905 -0.125520 +9112 2628 4 0 -18.667243 19.462095 -0.535183 +9113 2628 4 0 -18.065408 20.873029 -0.719025 +9114 2629 6 0 -22.940337 -3.988570 -9.248839 +9115 2629 4 0 -22.556330 -3.193733 -8.929657 +9116 2629 4 0 -23.624559 -3.640649 -9.848732 +9117 2630 6 0 12.039511 -1.981999 -19.397718 +9118 2630 4 0 12.283853 -1.068627 -19.717430 +9119 2630 4 0 11.293173 -1.821725 -18.743785 +9120 2631 6 0 26.340624 1.335259 19.289276 +9121 2631 4 0 26.841055 0.655996 19.819897 +9122 2631 4 0 26.800288 2.181296 19.386054 +9123 2632 6 0 5.916695 14.316365 5.690974 +9124 2632 4 0 6.301016 14.102416 4.790199 +9125 2632 4 0 5.065517 13.849361 5.701154 +9126 2633 6 0 13.370348 -18.821001 19.162682 +9127 2633 4 0 14.108633 -19.097802 18.663220 +9128 2633 4 0 13.699085 -18.168012 19.800526 +9129 2634 6 0 23.405805 15.068779 9.736213 +9130 2634 4 0 22.573160 14.660972 10.019951 +9131 2634 4 0 23.219623 15.734719 9.058682 +9132 2635 6 0 -5.408829 13.828838 18.447419 +9133 2635 4 0 -6.168561 13.481395 17.992340 +9134 2635 4 0 -4.784831 14.172206 17.836655 +9135 2636 6 0 -13.245623 5.670961 -0.018513 +9136 2636 4 0 -12.419620 5.936404 0.475256 +9137 2636 4 0 -12.953928 4.989305 -0.645525 +9138 2637 6 0 17.249203 -6.366308 2.555121 +9139 2637 4 0 18.196321 -6.281038 2.412817 +9140 2637 4 0 16.966298 -7.253693 2.384394 +9141 2638 6 0 -5.296416 19.864731 -1.668047 +9142 2638 4 0 -5.749980 19.031441 -1.444019 +9143 2638 4 0 -4.299943 19.722461 -1.604460 +9144 2639 6 0 -16.684535 5.831070 -9.866261 +9145 2639 4 0 -17.133431 6.510584 -9.314798 +9146 2639 4 0 -15.783199 6.112174 -9.905469 +9147 2640 6 0 16.265639 6.852785 -7.896636 +9148 2640 4 0 16.527802 6.700601 -8.808419 +9149 2640 4 0 17.070642 6.577942 -7.414049 +9150 2641 6 0 -21.312105 18.191924 10.459876 +9151 2641 4 0 -20.762633 18.843032 9.983997 +9152 2641 4 0 -20.749711 17.337404 10.555555 +9153 2642 6 0 -16.100357 -8.153697 -5.142815 +9154 2642 4 0 -16.563606 -8.364758 -6.004467 +9155 2642 4 0 -15.154250 -7.906094 -5.382181 +9156 2643 6 0 -9.615286 13.091225 20.211510 +9157 2643 4 0 -9.791366 12.655362 19.395743 +9158 2643 4 0 -10.462726 13.102852 20.699120 +9159 2644 6 0 -18.598056 -9.697384 8.839376 +9160 2644 4 0 -18.669310 -10.516686 9.343906 +9161 2644 4 0 -18.931363 -8.964428 9.385541 +9162 2645 6 0 7.933987 -14.093590 6.186519 +9163 2645 4 0 8.207527 -14.668399 6.884006 +9164 2645 4 0 8.301922 -13.235214 6.418423 +9165 2646 6 0 14.288937 4.874936 -8.228821 +9166 2646 4 0 13.542574 5.155680 -8.863279 +9167 2646 4 0 14.810343 5.654336 -8.058197 +9168 2647 6 0 12.246994 8.643633 9.863872 +9169 2647 4 0 12.726549 8.831956 10.652198 +9170 2647 4 0 11.373287 8.283693 10.003012 +9171 2648 6 0 -25.270711 -9.927997 8.533897 +9172 2648 4 0 -24.762785 -10.112710 9.286810 +9173 2648 4 0 -25.238676 -10.761122 8.058752 +9174 2649 6 0 22.391162 10.881778 -20.435148 +9175 2649 4 0 21.795271 11.117663 -21.128050 +9176 2649 4 0 22.356795 11.558284 -19.773744 +9177 2650 6 0 -0.807548 -14.371789 12.994860 +9178 2650 4 0 0.169556 -14.376294 13.074982 +9179 2650 4 0 -1.104471 -13.660037 12.471373 +9180 2651 6 0 7.732198 13.812736 20.037022 +9181 2651 4 0 8.322105 14.100985 20.697382 +9182 2651 4 0 7.280009 14.639584 19.691732 +9183 2652 6 0 19.803756 0.841082 -17.134900 +9184 2652 4 0 19.288798 0.974936 -16.312323 +9185 2652 4 0 20.344973 1.668924 -17.222026 +9186 2653 6 0 3.006216 10.098697 2.949568 +9187 2653 4 0 2.578021 10.984530 2.806805 +9188 2653 4 0 3.907142 10.297785 3.184074 +9189 2654 6 0 15.873541 13.013460 -17.893320 +9190 2654 4 0 15.039690 13.457379 -17.843027 +9191 2654 4 0 16.307486 13.271147 -17.069099 +9192 2655 6 0 17.084293 4.346353 -14.985379 +9193 2655 4 0 16.897186 4.218804 -15.905422 +9194 2655 4 0 18.061148 4.233803 -14.912436 +9195 2656 6 0 -21.371098 -2.500601 10.634104 +9196 2656 4 0 -21.050859 -3.246995 11.070174 +9197 2656 4 0 -21.156581 -2.501005 9.672558 +9198 2657 6 0 -18.750890 1.105436 13.107103 +9199 2657 4 0 -19.405065 0.422507 13.292755 +9200 2657 4 0 -18.176163 1.261421 13.836264 +9201 2658 6 0 -14.137019 19.297443 5.108564 +9202 2658 4 0 -14.447107 19.586959 4.301598 +9203 2658 4 0 -14.859255 19.041560 5.714699 +9204 2659 6 0 2.347144 -4.353199 10.184512 +9205 2659 4 0 3.047693 -4.789736 10.732160 +9206 2659 4 0 1.864240 -5.020658 9.719618 +9207 2660 6 0 8.101274 -12.868709 15.865572 +9208 2660 4 0 9.008432 -13.290947 15.950755 +9209 2660 4 0 8.164041 -12.117937 16.446599 +9210 2661 6 0 -7.675769 -15.390059 12.539289 +9211 2661 4 0 -7.409496 -14.626553 11.915042 +9212 2661 4 0 -7.614755 -16.191218 12.009248 +9213 2662 6 0 -21.398277 17.515428 0.659811 +9214 2662 4 0 -22.373476 17.461084 0.916402 +9215 2662 4 0 -21.187696 16.555626 0.790839 +9216 2663 6 0 -16.011532 15.600476 -5.525384 +9217 2663 4 0 -15.829552 14.648078 -5.450075 +9218 2663 4 0 -15.676036 15.915857 -6.377072 +9219 2664 6 0 -20.171456 -7.558847 9.362228 +9220 2664 4 0 -19.542732 -6.922489 9.041804 +9221 2664 4 0 -20.565885 -7.210783 10.122068 +9222 2665 6 0 -10.027028 2.569851 14.780708 +9223 2665 4 0 -10.957643 2.497925 14.922514 +9224 2665 4 0 -9.726024 3.392205 15.205842 +9225 2666 6 0 -12.389641 -3.630575 19.832870 +9226 2666 4 0 -12.243221 -2.721357 19.438252 +9227 2666 4 0 -11.816036 -4.199902 19.239521 +9228 2667 6 0 18.688398 -15.142019 -11.646870 +9229 2667 4 0 18.104901 -15.132683 -12.455435 +9230 2667 4 0 19.565818 -14.972254 -11.954461 +9231 2668 6 0 -16.127768 -4.186936 16.465789 +9232 2668 4 0 -16.199826 -5.136635 16.281789 +9233 2668 4 0 -15.213417 -3.948084 16.556706 +9234 2669 6 0 -5.695916 9.820869 12.533783 +9235 2669 4 0 -6.081058 9.297651 11.888045 +9236 2669 4 0 -6.375197 10.194994 13.105807 +9237 2670 6 0 -11.767595 7.371441 19.819990 +9238 2670 4 0 -12.489308 7.774706 20.373473 +9239 2670 4 0 -10.903774 7.497881 20.264329 +9240 2671 6 0 -18.646029 -3.188135 4.429231 +9241 2671 4 0 -18.121897 -2.394969 4.628228 +9242 2671 4 0 -19.564881 -3.024196 4.677418 +9243 2672 6 0 -27.199358 17.790334 15.106308 +9244 2672 4 0 -27.385927 16.881826 14.776421 +9245 2672 4 0 -27.100030 17.729872 16.057267 +9246 2673 6 0 18.093363 3.769702 -4.593442 +9247 2673 4 0 18.609903 3.037301 -4.942422 +9248 2673 4 0 18.650829 4.233336 -3.997439 +9249 2674 6 0 7.706432 11.586595 6.521802 +9250 2674 4 0 7.812472 12.398627 6.995928 +9251 2674 4 0 7.694286 11.737503 5.595545 +9252 2675 6 0 -23.496957 14.349318 18.036220 +9253 2675 4 0 -22.854057 14.699094 17.423607 +9254 2675 4 0 -22.990832 13.822071 18.687726 +9255 2676 6 0 -4.664327 -11.498090 8.919813 +9256 2676 4 0 -5.320061 -11.113845 8.334147 +9257 2676 4 0 -4.917357 -12.403653 9.095316 +9258 2677 6 0 -12.823426 10.100060 12.766547 +9259 2677 4 0 -13.732598 9.891677 12.621183 +9260 2677 4 0 -12.785614 10.926980 13.238539 +9261 2678 6 0 -17.217436 3.102574 -9.344857 +9262 2678 4 0 -16.824523 3.966216 -9.255133 +9263 2678 4 0 -18.161389 3.114177 -9.202666 +9264 2679 6 0 -19.237099 13.102459 19.268997 +9265 2679 4 0 -18.881981 13.843795 19.761617 +9266 2679 4 0 -18.662460 12.340333 19.526666 +9267 2680 6 0 -9.459329 4.127006 -20.423384 +9268 2680 4 0 -9.437953 4.152565 -21.392157 +9269 2680 4 0 -9.259556 3.201676 -20.170944 +9270 2681 6 0 16.881832 1.847629 -10.429065 +9271 2681 4 0 16.137346 2.355903 -10.841218 +9272 2681 4 0 16.970716 2.383474 -9.646384 +9273 2682 6 0 14.087997 4.886317 -18.329611 +9274 2682 4 0 13.870527 5.790902 -18.194453 +9275 2682 4 0 13.733176 4.313827 -17.614840 +9276 2683 6 0 -16.672076 -8.158476 12.371072 +9277 2683 4 0 -16.864374 -8.959184 11.822666 +9278 2683 4 0 -15.812107 -8.255964 12.755980 +9279 2684 6 0 -19.299758 3.045618 -4.235388 +9280 2684 4 0 -19.897059 2.549328 -3.677605 +9281 2684 4 0 -19.150628 3.861874 -3.750292 +9282 2685 6 0 -23.652514 -4.511442 -6.532734 +9283 2685 4 0 -22.727919 -4.287115 -6.467785 +9284 2685 4 0 -23.794359 -4.367125 -7.440392 +9285 2686 6 0 -2.920139 11.742479 14.018818 +9286 2686 4 0 -3.093279 11.094202 13.278761 +9287 2686 4 0 -2.213003 12.387804 13.722639 +9288 2687 6 0 26.349425 3.441434 -0.896655 +9289 2687 4 0 25.559323 3.941367 -0.786766 +9290 2687 4 0 26.827837 3.589174 -1.727789 +9291 2688 6 0 24.371024 -6.950117 11.157076 +9292 2688 4 0 24.363949 -7.335870 12.010991 +9293 2688 4 0 23.997586 -7.623084 10.641501 +9294 2689 6 0 -22.986862 7.597219 -10.685297 +9295 2689 4 0 -22.839220 7.363568 -11.582970 +9296 2689 4 0 -23.377355 8.488181 -10.698170 +9297 2690 6 0 -26.260863 2.606900 0.424694 +9298 2690 4 0 -25.763469 2.340546 -0.362004 +9299 2690 4 0 -27.210163 2.597209 0.142899 +9300 2691 6 0 -12.863331 19.210721 9.863577 +9301 2691 4 0 -12.261758 19.250393 10.674962 +9302 2691 4 0 -13.524604 18.506027 9.993308 +9303 2692 6 0 -21.978336 -14.820148 8.330413 +9304 2692 4 0 -21.114644 -14.929597 7.888749 +9305 2692 4 0 -21.801101 -14.612357 9.239922 +9306 2693 6 0 4.170159 8.312971 19.162038 +9307 2693 4 0 4.570566 7.905151 18.357550 +9308 2693 4 0 3.241810 8.258885 18.904642 +9309 2694 6 0 20.797031 -12.724867 -4.841837 +9310 2694 4 0 20.936034 -13.677427 -4.931553 +9311 2694 4 0 21.567394 -12.221377 -4.833917 +9312 2695 6 0 13.112963 4.999431 10.925314 +9313 2695 4 0 13.381193 5.910915 11.162187 +9314 2695 4 0 12.775168 5.031277 10.023795 +9315 2696 6 0 -17.488498 18.101828 -9.390547 +9316 2696 4 0 -16.811412 18.773847 -9.686587 +9317 2696 4 0 -17.803299 18.410345 -8.511456 +9318 2697 6 0 17.749103 -8.641103 -11.171278 +9319 2697 4 0 17.842099 -7.910400 -11.803229 +9320 2697 4 0 18.554099 -8.647320 -10.650095 +9321 2698 6 0 23.187132 -9.133014 9.904940 +9322 2698 4 0 23.460415 -9.970033 10.292082 +9323 2698 4 0 22.233888 -9.184916 9.742240 +9324 2699 6 0 14.891551 9.368784 -7.655561 +9325 2699 4 0 15.425686 8.571538 -7.734882 +9326 2699 4 0 15.193600 9.946038 -8.368338 +9327 2700 6 0 -23.866954 -2.554397 -3.337520 +9328 2700 4 0 -23.349227 -3.276607 -2.890486 +9329 2700 4 0 -24.593652 -2.997738 -3.796287 +9330 2701 6 0 5.289348 -7.469003 -13.632279 +9331 2701 4 0 5.277377 -6.512734 -13.514077 +9332 2701 4 0 5.158552 -7.590503 -14.588796 +9333 2702 6 0 -24.673900 -20.221091 14.116865 +9334 2702 4 0 -24.507583 -21.124377 14.341508 +9335 2702 4 0 -24.631103 -20.019803 13.186904 +9336 2703 6 0 23.849959 -2.905384 -13.612324 +9337 2703 4 0 23.991560 -2.301635 -14.360144 +9338 2703 4 0 23.035961 -3.322471 -13.648750 +9339 2704 6 0 9.597419 13.539609 16.458855 +9340 2704 4 0 8.786247 13.049602 16.392590 +9341 2704 4 0 9.783350 13.953319 15.588815 +9342 2705 6 0 25.970484 6.179678 15.798539 +9343 2705 4 0 26.018959 6.019011 14.863720 +9344 2705 4 0 26.760326 5.647911 16.135033 +9345 2706 6 0 15.995160 -8.299211 -19.360180 +9346 2706 4 0 16.084534 -7.778026 -20.183460 +9347 2706 4 0 16.045247 -9.240694 -19.615365 +9348 2707 6 0 -14.294639 13.545693 12.129310 +9349 2707 4 0 -14.596139 13.059241 11.355518 +9350 2707 4 0 -13.936091 12.903120 12.762555 +9351 2708 6 0 -19.407809 -1.632719 -10.223791 +9352 2708 4 0 -18.944881 -0.931680 -10.694558 +9353 2708 4 0 -19.337036 -2.518503 -10.649693 +9354 2709 6 0 19.353851 17.575670 17.852735 +9355 2709 4 0 19.970328 18.410638 17.937921 +9356 2709 4 0 18.705869 17.842357 17.182350 +9357 2710 6 0 7.952485 -13.835833 10.779314 +9358 2710 4 0 8.503126 -13.070419 11.090754 +9359 2710 4 0 7.207795 -13.430815 10.322018 +9360 2711 6 0 -22.842698 -2.314944 16.647836 +9361 2711 4 0 -23.333149 -1.519155 16.340397 +9362 2711 4 0 -23.463394 -3.038396 16.463743 +9363 2712 6 0 -19.201717 2.632915 18.127454 +9364 2712 4 0 -20.123441 2.325926 18.179315 +9365 2712 4 0 -19.210821 3.510831 17.811602 +9366 2713 6 0 14.940360 -1.960385 -5.022951 +9367 2713 4 0 15.464903 -2.467492 -5.627366 +9368 2713 4 0 15.028383 -1.068080 -5.249177 +9369 2714 6 0 18.305226 -9.507548 11.469011 +9370 2714 4 0 18.631115 -9.386360 12.404545 +9371 2714 4 0 17.861273 -8.670836 11.223009 +9372 2715 6 0 14.602066 10.381034 5.005010 +9373 2715 4 0 13.693795 10.430464 4.699453 +9374 2715 4 0 14.612959 10.041819 5.921815 +9375 2716 6 0 2.027713 14.335519 -2.737302 +9376 2716 4 0 2.701727 15.041848 -2.820213 +9377 2716 4 0 1.287972 14.760203 -2.236217 +9378 2717 6 0 7.583318 14.155640 -9.444813 +9379 2717 4 0 6.943304 13.664978 -8.934443 +9380 2717 4 0 7.541292 15.069839 -9.060789 +9381 2718 6 0 6.157219 -18.775945 -4.259618 +9382 2718 4 0 6.564876 -17.949995 -4.135465 +9383 2718 4 0 5.381952 -18.685791 -4.858352 +9384 2719 6 0 -17.694760 -19.372982 4.444716 +9385 2719 4 0 -18.482553 -19.775840 4.189782 +9386 2719 4 0 -17.768985 -18.373906 4.216234 +9387 2720 6 0 -7.853241 -10.893164 5.893751 +9388 2720 4 0 -8.018175 -11.113207 6.770281 +9389 2720 4 0 -8.721602 -10.559022 5.533534 +9390 2721 6 0 -0.179053 -16.316262 -6.972426 +9391 2721 4 0 -0.917372 -16.443486 -6.358316 +9392 2721 4 0 0.161491 -15.370029 -6.873414 +9393 2722 6 0 -17.840107 2.077389 4.804516 +9394 2722 4 0 -18.321956 2.898522 4.546830 +9395 2722 4 0 -17.883766 1.968309 5.738130 +9396 2723 6 0 22.514225 -13.301014 8.910658 +9397 2723 4 0 22.980267 -13.555893 9.738284 +9398 2723 4 0 22.816838 -13.961875 8.319245 +9399 2724 6 0 8.642838 -14.756688 -17.347259 +9400 2724 4 0 7.685639 -14.854800 -17.271066 +9401 2724 4 0 9.104821 -15.542415 -17.427483 +9402 2725 6 0 1.148414 -18.182410 2.438452 +9403 2725 4 0 1.244513 -18.018729 1.471145 +9404 2725 4 0 0.297784 -18.622295 2.484621 +9405 2726 6 0 -0.615129 -11.682105 -14.874888 +9406 2726 4 0 -0.743014 -12.466140 -15.424873 +9407 2726 4 0 -0.401037 -10.992229 -15.542345 +9408 2727 6 0 0.382292 8.435158 -17.928055 +9409 2727 4 0 1.324448 8.603691 -17.753474 +9410 2727 4 0 -0.034745 8.730008 -17.117939 +9411 2728 6 0 16.913096 -13.325161 -8.541691 +9412 2728 4 0 17.365381 -13.123665 -7.714485 +9413 2728 4 0 17.395114 -14.047333 -9.044404 +9414 2729 6 0 -21.295513 -11.021940 0.140848 +9415 2729 4 0 -20.399742 -11.414489 0.196618 +9416 2729 4 0 -21.717453 -11.457849 -0.596997 +9417 2730 6 0 16.257153 -20.396691 -7.748186 +9418 2730 4 0 15.866593 -21.141436 -8.252209 +9419 2730 4 0 16.774217 -20.799101 -7.019481 +9420 2731 6 0 0.208862 17.804049 -6.156398 +9421 2731 4 0 -0.761445 17.806961 -6.377662 +9422 2731 4 0 0.362977 16.942869 -5.716103 +9423 2732 6 0 16.820504 12.298715 0.018055 +9424 2732 4 0 17.269628 12.806166 0.753963 +9425 2732 4 0 16.616966 11.447779 0.422257 +9426 2733 6 0 8.249689 9.539413 -5.657026 +9427 2733 4 0 7.926267 8.961633 -4.961649 +9428 2733 4 0 7.466873 9.988595 -6.079963 +9429 2734 6 0 -6.420145 -15.194726 -2.072771 +9430 2734 4 0 -6.645150 -15.017421 -2.971457 +9431 2734 4 0 -5.532921 -14.874756 -2.025757 +9432 2735 6 0 -19.505572 1.070481 -18.793079 +9433 2735 4 0 -18.974247 1.767142 -19.229226 +9434 2735 4 0 -19.357244 1.271413 -17.799689 +9435 2736 6 0 20.278433 -11.278541 19.375197 +9436 2736 4 0 20.311617 -10.856797 20.258994 +9437 2736 4 0 20.934421 -12.034086 19.419062 +9438 2737 6 0 -10.619435 15.949865 1.585511 +9439 2737 4 0 -10.621509 15.567618 2.491670 +9440 2737 4 0 -10.362619 16.916267 1.609401 +9441 2738 6 0 -1.101917 -7.441924 10.586362 +9442 2738 4 0 -0.567999 -7.634893 11.314871 +9443 2738 4 0 -0.711206 -6.670438 10.158382 +9444 2739 6 0 -8.851165 -9.058377 -8.388886 +9445 2739 4 0 -9.044805 -8.277288 -8.905613 +9446 2739 4 0 -7.947771 -9.334823 -8.625881 +9447 2740 6 0 -12.865173 -20.003868 -17.685004 +9448 2740 4 0 -11.900331 -20.290871 -17.648188 +9449 2740 4 0 -13.259242 -20.215643 -16.805809 +9450 2741 6 0 8.134636 3.904853 11.647104 +9451 2741 4 0 7.339621 4.198944 12.086138 +9452 2741 4 0 8.359181 3.015108 11.941173 +9453 2742 6 0 19.642179 -0.232387 9.832126 +9454 2742 4 0 18.865134 -0.769467 9.662648 +9455 2742 4 0 19.348750 0.264237 10.621214 +9456 2743 6 0 -12.682747 8.424040 -10.230134 +9457 2743 4 0 -13.551445 8.389330 -9.854912 +9458 2743 4 0 -12.463391 9.379389 -10.339605 +9459 2744 6 0 26.914440 16.154997 -16.554272 +9460 2744 4 0 26.893167 15.808906 -17.482437 +9461 2744 4 0 26.594368 15.442541 -16.021243 +9462 2745 6 0 -6.756073 6.486074 12.621266 +9463 2745 4 0 -6.001614 6.299854 12.037502 +9464 2745 4 0 -7.537856 6.154367 12.136267 +9465 2746 6 0 -1.534934 -0.378729 -11.255488 +9466 2746 4 0 -1.019268 -0.077205 -12.015010 +9467 2746 4 0 -1.396223 0.199493 -10.524178 +9468 2747 6 0 -7.913402 -19.479583 -10.101731 +9469 2747 4 0 -7.094305 -19.451963 -10.661033 +9470 2747 4 0 -8.430321 -18.659348 -10.306663 +9471 2748 6 0 19.510276 5.438180 15.252043 +9472 2748 4 0 19.984510 4.581515 15.209276 +9473 2748 4 0 18.693891 5.265727 15.619608 +9474 2749 6 0 14.672317 -11.674219 -8.512325 +9475 2749 4 0 15.214654 -10.997268 -8.992741 +9476 2749 4 0 15.271629 -12.444207 -8.537082 +9477 2750 6 0 -26.549973 -17.678593 10.402834 +9478 2750 4 0 -25.763998 -17.483834 10.878590 +9479 2750 4 0 -27.160376 -17.361462 11.034196 +9480 2751 6 0 5.271179 14.438724 -17.415549 +9481 2751 4 0 4.435936 14.151626 -17.136425 +9482 2751 4 0 5.468504 14.023544 -18.253894 +9483 2752 6 0 26.352424 19.290788 19.181784 +9484 2752 4 0 26.638793 20.134863 19.511609 +9485 2752 4 0 27.096123 18.959221 18.597699 +9486 2753 6 0 -26.414188 7.441925 13.185744 +9487 2753 4 0 -26.562431 6.574296 12.885418 +9488 2753 4 0 -25.860420 7.846130 12.499402 +9489 2754 6 0 5.368816 -14.762666 -4.864027 +9490 2754 4 0 6.085752 -14.950510 -4.202359 +9491 2754 4 0 5.366848 -13.815827 -5.050153 +9492 2755 6 0 -1.852223 13.402453 16.099559 +9493 2755 4 0 -0.907053 13.096616 15.950410 +9494 2755 4 0 -2.405269 12.678324 16.442150 +9495 2756 6 0 -9.537989 1.018888 -17.294635 +9496 2756 4 0 -10.174283 0.989703 -18.011766 +9497 2756 4 0 -10.088090 0.844105 -16.509242 +9498 2757 6 0 -4.825860 2.375466 13.925597 +9499 2757 4 0 -4.190822 2.787671 13.323831 +9500 2757 4 0 -5.515449 3.033395 14.087300 +9501 2758 6 0 19.580327 -10.893880 -2.747248 +9502 2758 4 0 19.742431 -11.614878 -3.428406 +9503 2758 4 0 18.622372 -10.972265 -2.491828 +9504 2759 6 0 19.256086 14.705134 10.874402 +9505 2759 4 0 20.041175 14.096992 10.573737 +9506 2759 4 0 18.760180 14.026878 11.366191 +9507 2760 6 0 4.455935 -2.361452 20.137505 +9508 2760 4 0 3.955764 -1.509452 20.278229 +9509 2760 4 0 4.874829 -2.603490 21.001857 +9510 2761 6 0 -25.974850 13.344171 -18.000007 +9511 2761 4 0 -26.267499 12.457368 -18.163639 +9512 2761 4 0 -26.149308 13.539735 -17.037715 +9513 2762 6 0 17.067973 2.763490 17.660244 +9514 2762 4 0 16.915215 3.437471 16.973312 +9515 2762 4 0 17.816632 2.203161 17.314923 +9516 2763 6 0 -11.517545 18.040646 17.714435 +9517 2763 4 0 -11.560942 17.052444 17.749537 +9518 2763 4 0 -11.413962 18.230547 18.657315 +9519 2764 6 0 25.776483 -1.160860 1.258340 +9520 2764 4 0 26.324116 -0.766625 1.925968 +9521 2764 4 0 25.733053 -0.545865 0.469204 +9522 2765 6 0 0.465549 -19.018322 6.222139 +9523 2765 4 0 0.971697 -19.764727 5.842403 +9524 2765 4 0 1.099427 -18.538006 6.759456 +9525 2766 6 0 26.241049 -6.898960 18.643166 +9526 2766 4 0 25.947101 -5.963940 18.676752 +9527 2766 4 0 25.610721 -7.314304 19.228579 +9528 2767 6 0 16.134037 -10.035813 7.553052 +9529 2767 4 0 16.959970 -10.575559 7.222214 +9530 2767 4 0 16.256703 -9.244050 7.026849 +9531 2768 6 0 22.936475 16.842438 -13.354400 +9532 2768 4 0 23.113117 16.122413 -13.952998 +9533 2768 4 0 22.167217 17.380611 -13.705166 +9534 2769 6 0 -6.174635 -12.567358 -9.759225 +9535 2769 4 0 -7.056186 -12.732423 -10.081695 +9536 2769 4 0 -6.114005 -12.989145 -8.857709 +9537 2770 6 0 13.127494 -17.049020 5.559108 +9538 2770 4 0 12.909499 -17.802411 4.984143 +9539 2770 4 0 12.442780 -16.360937 5.316305 +9540 2771 6 0 10.969996 20.716828 15.837969 +9541 2771 4 0 10.927306 20.477406 14.883647 +9542 2771 4 0 11.840696 20.306837 16.078361 +9543 2772 6 0 13.866770 18.367517 6.937702 +9544 2772 4 0 13.986130 19.326827 7.078015 +9545 2772 4 0 14.231164 17.993652 7.716184 +9546 2773 6 0 13.832788 12.943646 -11.273375 +9547 2773 4 0 14.056108 12.521321 -12.121074 +9548 2773 4 0 13.085693 12.513389 -10.836623 +9549 2774 6 0 17.127641 6.332315 -10.642348 +9550 2774 4 0 16.719396 7.195424 -10.818370 +9551 2774 4 0 16.487151 5.750510 -10.856669 +9552 2775 6 0 7.636882 -18.482195 20.548956 +9553 2775 4 0 7.346233 -18.787052 19.666640 +9554 2775 4 0 8.040956 -17.608352 20.385186 +9555 2776 6 0 15.587474 -5.247845 -16.278347 +9556 2776 4 0 16.572338 -5.288530 -16.165720 +9557 2776 4 0 15.545571 -4.364820 -16.698452 +9558 2777 6 0 0.738994 10.421255 -19.729083 +9559 2777 4 0 0.031346 10.313580 -20.434784 +9560 2777 4 0 0.614162 9.625359 -19.156085 +9561 2778 6 0 -21.514700 17.398643 -8.313387 +9562 2778 4 0 -21.261038 18.368357 -8.523940 +9563 2778 4 0 -20.879597 16.869528 -8.849738 +9564 2779 6 0 21.659354 19.006928 20.763229 +9565 2779 4 0 22.346807 19.674088 20.960616 +9566 2779 4 0 22.147607 18.139994 20.600269 +9567 2780 6 0 -13.226723 20.003033 16.874806 +9568 2780 4 0 -12.786621 19.156341 16.987387 +9569 2780 4 0 -13.521849 20.036703 15.939938 +9570 2781 6 0 12.035825 14.976596 17.699907 +9571 2781 4 0 11.299148 14.549820 17.199522 +9572 2781 4 0 12.476396 14.244702 18.105024 +9573 2782 6 0 23.014725 11.421066 -1.195826 +9574 2782 4 0 22.935852 12.296840 -0.719881 +9575 2782 4 0 23.315744 11.556530 -2.052974 +9576 2783 6 0 21.005599 -13.607746 -17.329690 +9577 2783 4 0 20.264961 -13.783556 -16.739494 +9578 2783 4 0 21.692829 -14.155085 -17.164895 +9579 2784 6 0 19.390018 13.715877 -9.986126 +9580 2784 4 0 18.766137 13.984667 -10.642161 +9581 2784 4 0 18.882708 13.584906 -9.182021 +9582 2785 6 0 21.591458 2.844658 -17.196608 +9583 2785 4 0 21.687177 3.186923 -18.110216 +9584 2785 4 0 22.488513 2.580610 -17.004967 +9585 2786 6 0 11.345787 -11.914521 18.833564 +9586 2786 4 0 10.571637 -11.320431 18.801840 +9587 2786 4 0 11.974322 -11.433977 19.432443 +9588 2787 6 0 14.649482 -19.545223 8.356804 +9589 2787 4 0 14.003078 -18.851322 8.539351 +9590 2787 4 0 15.599308 -19.149367 8.338570 +9591 2788 6 0 -11.043193 -18.255867 17.281239 +9592 2788 4 0 -10.224926 -18.639865 16.994545 +9593 2788 4 0 -11.487164 -19.009987 17.634582 +9594 2789 6 0 -26.985345 -16.412246 -14.400881 +9595 2789 4 0 -27.454047 -15.606813 -14.379952 +9596 2789 4 0 -26.081841 -16.159237 -14.585861 +9597 2790 6 0 19.102051 -15.098666 -8.764412 +9598 2790 4 0 19.000932 -15.521094 -9.678404 +9599 2790 4 0 19.453733 -14.174347 -8.910357 +9600 2791 6 0 6.376012 19.349948 5.671135 +9601 2791 4 0 6.687862 20.029372 5.077314 +9602 2791 4 0 5.561947 19.709229 6.038539 +9603 2792 6 0 -17.499998 -13.507016 9.684050 +9604 2792 4 0 -17.138230 -13.962493 10.435127 +9605 2792 4 0 -17.640659 -14.284861 9.096248 +9606 2793 6 0 17.699807 -14.814698 11.789809 +9607 2793 4 0 17.014114 -15.422000 11.369433 +9608 2793 4 0 17.429825 -14.840034 12.737607 +9609 2794 6 0 12.888820 1.939624 -17.757092 +9610 2794 4 0 12.023501 2.459281 -17.778689 +9611 2794 4 0 12.922205 1.789197 -16.837552 +9612 2795 6 0 -27.142428 -4.791675 -8.608453 +9613 2795 4 0 -27.117499 -4.179414 -9.373351 +9614 2795 4 0 -26.563163 -5.561210 -8.869517 +9615 2796 6 0 18.673615 12.370651 6.319082 +9616 2796 4 0 18.699459 11.385010 6.253835 +9617 2796 4 0 18.583561 12.688817 5.434396 +9618 2797 6 0 10.178364 -12.605036 -17.136500 +9619 2797 4 0 10.699128 -12.924478 -16.370473 +9620 2797 4 0 9.489391 -13.311993 -17.195335 +9621 2798 6 0 7.257958 3.289333 16.273726 +9622 2798 4 0 7.801701 4.023865 16.654114 +9623 2798 4 0 6.831954 2.726700 16.945762 +9624 2799 6 0 -22.793525 -4.351149 1.112435 +9625 2799 4 0 -23.178683 -4.998212 1.686297 +9626 2799 4 0 -22.676437 -3.490820 1.495852 +9627 2800 6 0 10.431915 10.150385 6.416596 +9628 2800 4 0 9.504032 10.369808 6.525826 +9629 2800 4 0 10.818627 10.534325 7.222492 +9630 2801 6 0 16.181318 -18.659361 -4.530126 +9631 2801 4 0 16.539581 -18.491898 -3.640666 +9632 2801 4 0 16.723714 -18.083763 -5.128977 +9633 2802 6 0 24.085884 14.331318 -5.367949 +9634 2802 4 0 25.027794 14.190212 -5.345575 +9635 2802 4 0 23.725489 13.957121 -4.548465 +9636 2803 6 0 27.476267 18.553177 -13.120949 +9637 2803 4 0 27.278972 18.193548 -12.233661 +9638 2803 4 0 26.663894 18.473337 -13.667172 +9639 2804 6 0 -3.429941 10.490939 1.565767 +9640 2804 4 0 -4.189571 9.996973 1.988486 +9641 2804 4 0 -2.756994 10.462029 2.200444 +9642 2805 6 0 -23.874077 -2.287625 -14.406474 +9643 2805 4 0 -24.326434 -2.528790 -13.612508 +9644 2805 4 0 -23.725821 -1.349091 -14.150316 +9645 2806 6 0 6.913124 -5.939231 14.325196 +9646 2806 4 0 7.603991 -5.675852 13.760866 +9647 2806 4 0 7.141094 -6.840164 14.586103 +9648 2807 6 0 -9.435672 7.567999 -12.736311 +9649 2807 4 0 -10.092450 7.532344 -13.480723 +9650 2807 4 0 -9.904849 7.166688 -11.970693 +9651 2808 6 0 -23.627772 20.561997 -10.291642 +9652 2808 4 0 -23.140188 21.403417 -10.120507 +9653 2808 4 0 -23.127330 19.939171 -10.860601 +9654 2809 6 0 -11.957151 -10.758767 10.380421 +9655 2809 4 0 -12.914975 -11.025570 10.474104 +9656 2809 4 0 -11.726864 -10.328942 11.254768 +9657 2810 6 0 -4.055025 -16.357375 12.638110 +9658 2810 4 0 -4.145602 -15.539307 12.188903 +9659 2810 4 0 -3.229424 -16.754351 12.492730 +9660 2811 6 0 -25.660951 2.977355 3.644209 +9661 2811 4 0 -25.405729 3.847728 3.825406 +9662 2811 4 0 -26.592530 3.015138 3.572516 +9663 2812 6 0 -1.059386 -9.814838 20.360215 +9664 2812 4 0 -0.131280 -9.654603 20.258879 +9665 2812 4 0 -1.404044 -10.175480 19.521783 +9666 2813 6 0 -13.274409 -12.355600 6.487680 +9667 2813 4 0 -14.175655 -12.374044 6.195808 +9668 2813 4 0 -12.869043 -11.626070 5.932127 +9669 2814 6 0 -17.154642 -17.337539 -2.602671 +9670 2814 4 0 -17.684268 -17.711860 -3.323318 +9671 2814 4 0 -17.542126 -17.638492 -1.768263 +9672 2815 6 0 -8.431986 -14.331490 -18.620988 +9673 2815 4 0 -8.525378 -14.518157 -17.652352 +9674 2815 4 0 -9.070115 -15.091242 -18.962501 +9675 2816 6 0 9.227734 -14.707755 8.334683 +9676 2816 4 0 8.912750 -14.297078 9.180099 +9677 2816 4 0 10.141362 -14.864367 8.460368 +9678 2817 6 0 -18.940927 -7.749229 13.986681 +9679 2817 4 0 -18.998677 -8.736236 14.046068 +9680 2817 4 0 -18.235160 -7.570709 13.352401 +9681 2818 6 0 -3.315848 14.486693 12.321029 +9682 2818 4 0 -2.891118 14.428375 11.433488 +9683 2818 4 0 -3.009257 15.355409 12.649294 +9684 2819 6 0 15.258302 19.640916 -9.495586 +9685 2819 4 0 15.255790 19.268774 -10.417780 +9686 2819 4 0 14.362167 19.825595 -9.329840 +9687 2820 6 0 -27.308827 -17.253050 -3.549375 +9688 2820 4 0 -27.016406 -16.762829 -2.812626 +9689 2820 4 0 -26.618283 -17.291456 -4.216078 +9690 2821 6 0 -17.469474 9.268976 13.624133 +9691 2821 4 0 -17.003981 8.734120 14.281842 +9692 2821 4 0 -17.567961 10.133200 14.047196 +9693 2822 6 0 20.896249 -8.668059 -15.648620 +9694 2822 4 0 21.320419 -8.468808 -14.797523 +9695 2822 4 0 20.936901 -9.602395 -15.783740 +9696 2823 6 0 6.591038 13.945476 -6.677072 +9697 2823 4 0 6.387452 12.989743 -6.664344 +9698 2823 4 0 7.535066 14.092588 -6.670539 +9699 2824 6 0 10.072634 7.484666 6.879205 +9700 2824 4 0 9.218040 7.159172 6.564500 +9701 2824 4 0 10.122197 8.421774 6.591601 +9702 2825 6 0 -23.792275 5.951536 11.433857 +9703 2825 4 0 -23.560372 6.167334 12.401775 +9704 2825 4 0 -23.076924 6.327786 10.856454 +9705 2826 6 0 12.132840 3.851033 -6.616749 +9706 2826 4 0 12.785083 4.216573 -7.191058 +9707 2826 4 0 12.512257 3.897859 -5.719717 +9708 2827 6 0 5.351683 6.078049 -14.255102 +9709 2827 4 0 5.013358 6.855687 -13.813494 +9710 2827 4 0 5.137704 6.252225 -15.124513 +9711 2828 6 0 13.138157 -8.336001 1.684188 +9712 2828 4 0 12.595335 -8.813255 1.081700 +9713 2828 4 0 13.382247 -7.459796 1.264391 +9714 2829 6 0 -10.347292 10.399621 -12.874082 +9715 2829 4 0 -10.494653 9.452942 -12.814808 +9716 2829 4 0 -10.828227 10.775518 -13.651328 +9717 2830 6 0 9.152946 -17.315622 6.377534 +9718 2830 4 0 8.873272 -17.655423 5.536131 +9719 2830 4 0 9.644625 -16.466151 6.247065 +9720 2831 6 0 -2.422355 -14.638070 -20.255326 +9721 2831 4 0 -2.466677 -15.603006 -20.125891 +9722 2831 4 0 -2.234204 -14.630853 -21.192244 +9723 2832 6 0 7.306601 16.960372 -8.356338 +9724 2832 4 0 7.335426 17.713766 -8.966973 +9725 2832 4 0 6.389385 16.681622 -8.314986 +9726 2833 6 0 -11.068015 -16.691381 7.975224 +9727 2833 4 0 -11.725330 -17.098102 8.584468 +9728 2833 4 0 -11.554703 -15.995305 7.530686 +9729 2834 6 0 2.086903 -14.793471 13.604939 +9730 2834 4 0 2.196059 -15.680487 13.948768 +9731 2834 4 0 2.568411 -14.755595 12.759739 +9732 2835 6 0 -17.658207 18.277094 2.186303 +9733 2835 4 0 -17.424686 17.674490 1.472227 +9734 2835 4 0 -18.244002 18.909136 1.776504 +9735 2836 6 0 24.999903 10.057013 0.434977 +9736 2836 4 0 24.330807 10.404778 -0.199378 +9737 2836 4 0 24.595385 9.375992 1.021837 + +Bonds + +1 1 1 2 +2 2 1 5 +3 2 1 6 +4 2 1 7 +5 3 2 3 +6 4 2 8 +7 5 2 9 +8 6 3 4 +9 7 3 20 +10 8 9 10 +11 9 9 13 +12 9 9 14 +13 10 10 11 +14 9 10 15 +15 9 10 16 +16 10 11 12 +17 9 12 17 +18 9 12 18 +19 9 12 19 +20 11 20 21 +21 12 20 24 +22 3 21 22 +23 4 21 25 +24 5 21 26 +25 6 22 23 +26 7 22 37 +27 8 26 27 +28 9 26 31 +29 9 26 32 +30 13 27 28 +31 9 27 33 +32 9 27 34 +33 6 28 29 +34 7 28 30 +35 12 30 35 +36 12 30 36 +37 11 37 38 +38 12 37 41 +39 3 38 39 +40 4 38 42 +41 14 38 43 +42 6 39 40 +43 7 39 56 +44 5 43 44 +45 5 43 45 +46 4 43 47 +47 8 44 46 +48 9 44 48 +49 9 44 49 +50 9 45 50 +51 9 45 51 +52 9 45 52 +53 9 46 53 +54 9 46 54 +55 9 46 55 +56 11 56 57 +57 12 56 60 +58 3 57 58 +59 4 57 61 +60 5 57 62 +61 6 58 59 +62 7 58 76 +63 15 62 63 +64 9 62 69 +65 9 62 70 +66 16 63 64 +67 16 63 65 +68 16 64 66 +69 17 64 71 +70 16 65 67 +71 17 65 72 +72 16 66 68 +73 17 66 73 +74 16 67 68 +75 17 67 74 +76 17 68 75 +77 11 76 77 +78 12 76 80 +79 3 77 78 +80 4 77 81 +81 14 77 82 +82 6 78 79 +83 7 78 92 +84 5 82 83 +85 5 82 84 +86 4 82 85 +87 9 83 86 +88 9 83 87 +89 9 83 88 +90 9 84 89 +91 9 84 90 +92 9 84 91 +93 11 92 93 +94 12 92 96 +95 3 93 94 +96 4 93 97 +97 5 93 98 +98 6 94 95 +99 7 94 114 +100 8 98 99 +101 9 98 103 +102 9 98 104 +103 8 99 100 +104 9 99 105 +105 9 99 106 +106 8 100 101 +107 9 100 107 +108 9 100 108 +109 18 101 102 +110 9 101 109 +111 9 101 110 +112 19 102 111 +113 19 102 112 +114 19 102 113 +115 11 114 115 +116 12 114 118 +117 3 115 116 +118 4 115 119 +119 14 115 120 +120 6 116 117 +121 7 116 128 +122 20 120 121 +123 5 120 122 +124 4 120 123 +125 21 121 124 +126 9 122 125 +127 9 122 126 +128 9 122 127 +129 11 128 129 +130 12 128 132 +131 3 129 130 +132 4 129 133 +133 5 129 134 +134 6 130 131 +135 7 130 147 +136 5 134 135 +137 9 134 138 +138 9 134 139 +139 5 135 136 +140 5 135 137 +141 4 135 140 +142 9 136 141 +143 9 136 142 +144 9 136 143 +145 9 137 144 +146 9 137 145 +147 9 137 146 +148 11 147 148 +149 12 147 151 +150 3 148 149 +151 4 148 152 +152 14 148 153 +153 6 149 150 +154 7 149 161 +155 20 153 154 +156 5 153 155 +157 4 153 156 +158 21 154 157 +159 9 155 158 +160 9 155 159 +161 9 155 160 +162 22 161 162 +163 12 161 165 +164 23 162 163 +165 24 162 166 +166 24 162 167 +167 6 163 164 +168 7 163 168 +169 11 168 169 +170 12 168 172 +171 3 169 170 +172 4 169 173 +173 5 169 174 +174 6 170 171 +175 7 170 190 +176 8 174 175 +177 9 174 179 +178 9 174 180 +179 8 175 176 +180 9 175 181 +181 9 175 182 +182 8 176 177 +183 9 176 183 +184 9 176 184 +185 18 177 178 +186 9 177 185 +187 9 177 186 +188 19 178 187 +189 19 178 188 +190 19 178 189 +191 11 190 191 +192 12 190 194 +193 3 191 192 +194 4 191 195 +195 14 191 196 +196 6 192 193 +197 7 192 204 +198 20 196 197 +199 5 196 198 +200 4 196 199 +201 21 197 200 +202 9 198 201 +203 9 198 202 +204 9 198 203 +205 11 204 205 +206 12 204 208 +207 3 205 206 +208 4 205 209 +209 14 205 210 +210 6 206 207 +211 7 206 223 +212 5 210 211 +213 5 210 212 +214 4 210 214 +215 8 211 213 +216 9 211 215 +217 9 211 216 +218 9 212 217 +219 9 212 218 +220 9 212 219 +221 9 213 220 +222 9 213 221 +223 9 213 222 +224 11 223 224 +225 12 223 227 +226 3 224 225 +227 4 224 228 +228 14 224 229 +229 6 225 226 +230 7 225 237 +231 20 229 230 +232 5 229 231 +233 4 229 232 +234 21 230 233 +235 9 231 234 +236 9 231 235 +237 9 231 236 +238 11 237 238 +239 12 237 241 +240 3 238 239 +241 4 238 242 +242 5 238 243 +243 6 239 240 +244 7 239 256 +245 5 243 244 +246 9 243 247 +247 9 243 248 +248 5 244 245 +249 5 244 246 +250 4 244 249 +251 9 245 250 +252 9 245 251 +253 9 245 252 +254 9 246 253 +255 9 246 254 +256 9 246 255 +257 11 256 257 +258 12 256 260 +259 3 257 258 +260 4 257 261 +261 5 257 262 +262 6 258 259 +263 7 258 271 +264 8 262 263 +265 9 262 267 +266 9 262 268 +267 25 263 264 +268 9 263 269 +269 9 263 270 +270 26 264 265 +271 26 264 266 +272 11 271 272 +273 12 271 275 +274 3 272 273 +275 4 272 276 +276 14 272 277 +277 6 273 274 +278 7 273 287 +279 5 277 278 +280 5 277 279 +281 4 277 280 +282 9 278 281 +283 9 278 282 +284 9 278 283 +285 9 279 284 +286 9 279 285 +287 9 279 286 +288 11 287 288 +289 12 287 291 +290 3 288 289 +291 4 288 292 +292 5 288 293 +293 6 289 290 +294 27 289 302 +295 8 293 294 +296 9 293 298 +297 9 293 299 +298 25 294 295 +299 9 294 300 +300 9 294 301 +301 26 295 296 +302 26 295 297 +303 28 302 303 +304 29 302 309 +305 3 303 304 +306 4 303 306 +307 30 303 307 +308 6 304 305 +309 7 304 316 +310 31 307 308 +311 32 307 310 +312 32 307 311 +313 31 308 309 +314 32 308 312 +315 32 308 313 +316 33 309 314 +317 33 309 315 +318 11 316 317 +319 12 316 320 +320 3 317 318 +321 4 317 321 +322 5 317 322 +323 6 318 319 +324 7 318 327 +325 34 322 323 +326 9 322 324 +327 9 322 325 +328 21 323 326 +329 11 327 328 +330 12 327 331 +331 3 328 329 +332 4 328 332 +333 5 328 333 +334 6 329 330 +335 7 329 339 +336 25 333 334 +337 9 333 337 +338 9 333 338 +339 26 334 335 +340 26 334 336 +341 11 339 340 +342 12 339 343 +343 3 340 341 +344 4 340 344 +345 14 340 345 +346 6 341 342 +347 7 341 353 +348 20 345 346 +349 5 345 347 +350 4 345 348 +351 21 346 349 +352 9 347 350 +353 9 347 351 +354 9 347 352 +355 11 353 354 +356 12 353 357 +357 3 354 355 +358 4 354 358 +359 14 354 359 +360 6 355 356 +361 7 355 372 +362 5 359 360 +363 5 359 361 +364 4 359 363 +365 8 360 362 +366 9 360 364 +367 9 360 365 +368 9 361 366 +369 9 361 367 +370 9 361 368 +371 9 362 369 +372 9 362 370 +373 9 362 371 +374 11 372 373 +375 12 372 376 +376 3 373 374 +377 4 373 377 +378 5 373 378 +379 6 374 375 +380 7 374 387 +381 8 378 379 +382 9 378 383 +383 9 378 384 +384 25 379 380 +385 9 379 385 +386 9 379 386 +387 26 380 381 +388 26 380 382 +389 11 387 388 +390 12 387 391 +391 3 388 389 +392 4 388 392 +393 5 388 393 +394 6 389 390 +395 7 389 401 +396 13 393 394 +397 9 393 397 +398 9 393 398 +399 6 394 395 +400 7 394 396 +401 12 396 399 +402 12 396 400 +403 11 401 402 +404 12 401 405 +405 3 402 403 +406 4 402 406 +407 14 402 407 +408 6 403 404 +409 7 403 417 +410 5 407 408 +411 5 407 409 +412 4 407 410 +413 9 408 411 +414 9 408 412 +415 9 408 413 +416 9 409 414 +417 9 409 415 +418 9 409 416 +419 11 417 418 +420 12 417 421 +421 3 418 419 +422 4 418 422 +423 5 418 423 +424 6 419 420 +425 7 419 439 +426 8 423 424 +427 9 423 428 +428 9 423 429 +429 8 424 425 +430 9 424 430 +431 9 424 431 +432 8 425 426 +433 9 425 432 +434 9 425 433 +435 18 426 427 +436 9 426 434 +437 9 426 435 +438 19 427 436 +439 19 427 437 +440 19 427 438 +441 11 439 440 +442 12 439 443 +443 3 440 441 +444 4 440 444 +445 5 440 445 +446 6 441 442 +447 7 441 449 +448 9 445 446 +449 9 445 447 +450 9 445 448 +451 11 449 450 +452 12 449 453 +453 3 450 451 +454 4 450 454 +455 5 450 455 +456 6 451 452 +457 7 451 471 +458 8 455 456 +459 9 455 460 +460 9 455 461 +461 8 456 457 +462 9 456 462 +463 9 456 463 +464 8 457 458 +465 9 457 464 +466 9 457 465 +467 18 458 459 +468 9 458 466 +469 9 458 467 +470 19 459 468 +471 19 459 469 +472 19 459 470 +473 11 471 472 +474 12 471 475 +475 3 472 473 +476 4 472 476 +477 14 472 477 +478 6 473 474 +479 7 473 490 +480 5 477 478 +481 5 477 479 +482 4 477 481 +483 8 478 480 +484 9 478 482 +485 9 478 483 +486 9 479 484 +487 9 479 485 +488 9 479 486 +489 9 480 487 +490 9 480 488 +491 9 480 489 +492 11 490 491 +493 12 490 494 +494 3 491 492 +495 4 491 495 +496 5 491 496 +497 6 492 493 +498 7 492 507 +499 8 496 497 +500 9 496 501 +501 9 496 502 +502 13 497 498 +503 9 497 503 +504 9 497 504 +505 6 498 499 +506 7 498 500 +507 12 500 505 +508 12 500 506 +509 11 507 508 +510 12 507 511 +511 3 508 509 +512 4 508 512 +513 5 508 513 +514 6 509 510 +515 7 509 519 +516 25 513 514 +517 9 513 517 +518 9 513 518 +519 26 514 515 +520 26 514 516 +521 11 519 520 +522 12 519 523 +523 3 520 521 +524 4 520 524 +525 5 520 525 +526 6 521 522 +527 7 521 541 +528 8 525 526 +529 9 525 530 +530 9 525 531 +531 8 526 527 +532 9 526 532 +533 9 526 533 +534 8 527 528 +535 9 527 534 +536 9 527 535 +537 18 528 529 +538 9 528 536 +539 9 528 537 +540 19 529 538 +541 19 529 539 +542 19 529 540 +543 11 541 542 +544 12 541 545 +545 3 542 543 +546 4 542 546 +547 5 542 547 +548 6 543 544 +549 7 543 556 +550 8 547 548 +551 9 547 552 +552 9 547 553 +553 25 548 549 +554 9 548 554 +555 9 548 555 +556 26 549 550 +557 26 549 551 +558 22 556 557 +559 12 556 560 +560 23 557 558 +561 24 557 561 +562 24 557 562 +563 6 558 559 +564 7 558 563 +565 11 563 564 +566 12 563 567 +567 3 564 565 +568 4 564 568 +569 14 564 569 +570 6 565 566 +571 27 565 582 +572 5 569 570 +573 5 569 571 +574 4 569 573 +575 8 570 572 +576 9 570 574 +577 9 570 575 +578 9 571 576 +579 9 571 577 +580 9 571 578 +581 9 572 579 +582 9 572 580 +583 9 572 581 +584 28 582 583 +585 29 582 589 +586 3 583 584 +587 4 583 586 +588 30 583 587 +589 6 584 585 +590 27 584 596 +591 31 587 588 +592 32 587 590 +593 32 587 591 +594 31 588 589 +595 32 588 592 +596 32 588 593 +597 33 589 594 +598 33 589 595 +599 28 596 597 +600 29 596 603 +601 3 597 598 +602 4 597 600 +603 30 597 601 +604 6 598 599 +605 7 598 610 +606 31 601 602 +607 32 601 604 +608 32 601 605 +609 31 602 603 +610 32 602 606 +611 32 602 607 +612 33 603 608 +613 33 603 609 +614 11 610 611 +615 12 610 614 +616 3 611 612 +617 4 611 615 +618 5 611 616 +619 6 612 613 +620 7 612 622 +621 25 616 617 +622 9 616 620 +623 9 616 621 +624 26 617 618 +625 26 617 619 +626 11 622 623 +627 12 622 626 +628 3 623 624 +629 4 623 627 +630 5 623 628 +631 6 624 625 +632 7 624 639 +633 8 628 629 +634 9 628 633 +635 9 628 634 +636 13 629 630 +637 9 629 635 +638 9 629 636 +639 6 630 631 +640 7 630 632 +641 12 632 637 +642 12 632 638 +643 11 639 640 +644 12 639 643 +645 3 640 641 +646 4 640 644 +647 5 640 645 +648 6 641 642 +649 7 641 656 +650 8 645 646 +651 9 645 650 +652 9 645 651 +653 13 646 647 +654 9 646 652 +655 9 646 653 +656 6 647 648 +657 7 647 649 +658 12 649 654 +659 12 649 655 +660 11 656 657 +661 12 656 660 +662 3 657 658 +663 4 657 661 +664 5 657 662 +665 6 658 659 +666 7 658 680 +667 8 662 663 +668 9 662 669 +669 9 662 670 +670 8 663 664 +671 9 663 671 +672 9 663 672 +673 35 664 665 +674 9 664 673 +675 9 664 674 +676 36 665 666 +677 37 665 675 +678 36 666 667 +679 36 666 668 +680 37 667 676 +681 37 667 677 +682 37 668 678 +683 37 668 679 +684 11 680 681 +685 12 680 684 +686 3 681 682 +687 4 681 685 +688 5 681 686 +689 6 682 683 +690 7 682 699 +691 5 686 687 +692 9 686 690 +693 9 686 691 +694 5 687 688 +695 5 687 689 +696 4 687 692 +697 9 688 693 +698 9 688 694 +699 9 688 695 +700 9 689 696 +701 9 689 697 +702 9 689 698 +703 11 699 700 +704 12 699 703 +705 3 700 701 +706 4 700 704 +707 14 700 705 +708 6 701 702 +709 7 701 718 +710 5 705 706 +711 5 705 707 +712 4 705 709 +713 8 706 708 +714 9 706 710 +715 9 706 711 +716 9 707 712 +717 9 707 713 +718 9 707 714 +719 9 708 715 +720 9 708 716 +721 9 708 717 +722 11 718 719 +723 12 718 722 +724 3 719 720 +725 4 719 723 +726 5 719 724 +727 6 720 721 +728 7 720 738 +729 15 724 725 +730 9 724 731 +731 9 724 732 +732 16 725 726 +733 16 725 727 +734 16 726 728 +735 17 726 733 +736 16 727 729 +737 17 727 734 +738 16 728 730 +739 17 728 735 +740 16 729 730 +741 17 729 736 +742 17 730 737 +743 11 738 739 +744 12 738 742 +745 3 739 740 +746 4 739 743 +747 5 739 744 +748 6 740 741 +749 7 740 748 +750 9 744 745 +751 9 744 746 +752 9 744 747 +753 22 748 749 +754 12 748 752 +755 23 749 750 +756 24 749 753 +757 24 749 754 +758 6 750 751 +759 7 750 755 +760 11 755 756 +761 12 755 759 +762 3 756 757 +763 4 756 760 +764 5 756 761 +765 6 757 758 +766 7 757 777 +767 8 761 762 +768 9 761 766 +769 9 761 767 +770 8 762 763 +771 9 762 768 +772 9 762 769 +773 8 763 764 +774 9 763 770 +775 9 763 771 +776 18 764 765 +777 9 764 772 +778 9 764 773 +779 19 765 774 +780 19 765 775 +781 19 765 776 +782 11 777 778 +783 12 777 781 +784 3 778 779 +785 4 778 782 +786 5 778 783 +787 6 779 780 +788 7 779 794 +789 8 783 784 +790 9 783 788 +791 9 783 789 +792 13 784 785 +793 9 784 790 +794 9 784 791 +795 6 785 786 +796 7 785 787 +797 12 787 792 +798 12 787 793 +799 11 794 795 +800 12 794 798 +801 3 795 796 +802 4 795 799 +803 5 795 800 +804 6 796 797 +805 7 796 813 +806 5 800 801 +807 9 800 804 +808 9 800 805 +809 5 801 802 +810 5 801 803 +811 4 801 806 +812 9 802 807 +813 9 802 808 +814 9 802 809 +815 9 803 810 +816 9 803 811 +817 9 803 812 +818 11 813 814 +819 12 813 817 +820 3 814 815 +821 4 814 818 +822 5 814 819 +823 6 815 816 +824 7 815 828 +825 8 819 820 +826 9 819 824 +827 9 819 825 +828 25 820 821 +829 9 820 826 +830 9 820 827 +831 26 821 822 +832 26 821 823 +833 11 828 829 +834 12 828 832 +835 3 829 830 +836 4 829 833 +837 5 829 834 +838 6 830 831 +839 7 830 840 +840 25 834 835 +841 9 834 838 +842 9 834 839 +843 26 835 836 +844 26 835 837 +845 22 840 841 +846 12 840 844 +847 23 841 842 +848 24 841 845 +849 24 841 846 +850 6 842 843 +851 7 842 847 +852 11 847 848 +853 12 847 851 +854 3 848 849 +855 4 848 852 +856 5 848 853 +857 6 849 850 +858 7 849 871 +859 8 853 854 +860 9 853 860 +861 9 853 861 +862 8 854 855 +863 9 854 862 +864 9 854 863 +865 35 855 856 +866 9 855 864 +867 9 855 865 +868 36 856 857 +869 37 856 866 +870 36 857 858 +871 36 857 859 +872 37 858 867 +873 37 858 868 +874 37 859 869 +875 37 859 870 +876 11 871 872 +877 12 871 875 +878 3 872 873 +879 4 872 876 +880 14 872 877 +881 6 873 874 +882 7 873 885 +883 20 877 878 +884 5 877 879 +885 4 877 880 +886 21 878 881 +887 9 879 882 +888 9 879 883 +889 9 879 884 +890 11 885 886 +891 12 885 889 +892 3 886 887 +893 4 886 890 +894 5 886 891 +895 6 887 888 +896 7 887 904 +897 5 891 892 +898 9 891 895 +899 9 891 896 +900 5 892 893 +901 5 892 894 +902 4 892 897 +903 9 893 898 +904 9 893 899 +905 9 893 900 +906 9 894 901 +907 9 894 902 +908 9 894 903 +909 11 904 905 +910 12 904 908 +911 3 905 906 +912 4 905 909 +913 5 905 910 +914 6 906 907 +915 7 906 915 +916 34 910 911 +917 9 910 912 +918 9 910 913 +919 21 911 914 +920 11 915 916 +921 12 915 919 +922 3 916 917 +923 4 916 920 +924 5 916 921 +925 6 917 918 +926 7 917 927 +927 25 921 922 +928 9 921 925 +929 9 921 926 +930 26 922 923 +931 26 922 924 +932 11 927 928 +933 12 927 931 +934 3 928 929 +935 4 928 932 +936 5 928 933 +937 6 929 930 +938 7 929 948 +939 15 933 934 +940 9 933 941 +941 9 933 942 +942 16 934 935 +943 16 934 936 +944 16 935 937 +945 17 935 943 +946 16 936 938 +947 17 936 944 +948 16 937 939 +949 17 937 945 +950 16 938 939 +951 17 938 946 +952 38 939 940 +953 39 940 947 +954 11 948 949 +955 12 948 952 +956 3 949 950 +957 4 949 953 +958 5 949 954 +959 6 950 951 +960 7 950 962 +961 13 954 955 +962 9 954 958 +963 9 954 959 +964 6 955 956 +965 7 955 957 +966 12 957 960 +967 12 957 961 +968 11 962 963 +969 12 962 966 +970 3 963 964 +971 4 963 967 +972 14 963 968 +973 6 964 965 +974 7 964 981 +975 5 968 969 +976 5 968 970 +977 4 968 972 +978 8 969 971 +979 9 969 973 +980 9 969 974 +981 9 970 975 +982 9 970 976 +983 9 970 977 +984 9 971 978 +985 9 971 979 +986 9 971 980 +987 11 981 982 +988 12 981 985 +989 3 982 983 +990 4 982 986 +991 5 982 987 +992 6 983 984 +993 7 983 998 +994 8 987 988 +995 9 987 992 +996 9 987 993 +997 13 988 989 +998 9 988 994 +999 9 988 995 +1000 6 989 990 +1001 7 989 991 +1002 12 991 996 +1003 12 991 997 +1004 11 998 999 +1005 12 998 1002 +1006 3 999 1000 +1007 4 999 1003 +1008 5 999 1004 +1009 6 1000 1001 +1010 7 1000 1020 +1011 8 1004 1005 +1012 9 1004 1009 +1013 9 1004 1010 +1014 8 1005 1006 +1015 9 1005 1011 +1016 9 1005 1012 +1017 8 1006 1007 +1018 9 1006 1013 +1019 9 1006 1014 +1020 18 1007 1008 +1021 9 1007 1015 +1022 9 1007 1016 +1023 19 1008 1017 +1024 19 1008 1018 +1025 19 1008 1019 +1026 11 1020 1021 +1027 12 1020 1024 +1028 3 1021 1022 +1029 4 1021 1025 +1030 5 1021 1026 +1031 6 1022 1023 +1032 7 1022 1035 +1033 8 1026 1027 +1034 9 1026 1031 +1035 9 1026 1032 +1036 25 1027 1028 +1037 9 1027 1033 +1038 9 1027 1034 +1039 26 1028 1029 +1040 26 1028 1030 +1041 11 1035 1036 +1042 12 1035 1039 +1043 3 1036 1037 +1044 4 1036 1040 +1045 5 1036 1041 +1046 6 1037 1038 +1047 7 1037 1046 +1048 34 1041 1042 +1049 9 1041 1043 +1050 9 1041 1044 +1051 21 1042 1045 +1052 11 1046 1047 +1053 12 1046 1050 +1054 3 1047 1048 +1055 4 1047 1051 +1056 14 1047 1052 +1057 6 1048 1049 +1058 7 1048 1060 +1059 20 1052 1053 +1060 5 1052 1054 +1061 4 1052 1055 +1062 21 1053 1056 +1063 9 1054 1057 +1064 9 1054 1058 +1065 9 1054 1059 +1066 11 1060 1061 +1067 12 1060 1064 +1068 3 1061 1062 +1069 4 1061 1065 +1070 5 1061 1066 +1071 6 1062 1063 +1072 7 1062 1079 +1073 5 1066 1067 +1074 9 1066 1070 +1075 9 1066 1071 +1076 5 1067 1068 +1077 5 1067 1069 +1078 4 1067 1072 +1079 9 1068 1073 +1080 9 1068 1074 +1081 9 1068 1075 +1082 9 1069 1076 +1083 9 1069 1077 +1084 9 1069 1078 +1085 11 1079 1080 +1086 12 1079 1083 +1087 3 1080 1081 +1088 4 1080 1084 +1089 5 1080 1085 +1090 6 1081 1082 +1091 7 1081 1097 +1092 40 1085 1086 +1093 9 1085 1091 +1094 9 1085 1092 +1095 41 1086 1087 +1096 42 1086 1088 +1097 43 1087 1089 +1098 44 1087 1093 +1099 41 1088 1090 +1100 45 1088 1094 +1101 43 1089 1090 +1102 46 1089 1095 +1103 44 1090 1096 +1104 11 1097 1098 +1105 12 1097 1101 +1106 3 1098 1099 +1107 4 1098 1102 +1108 5 1098 1103 +1109 6 1099 1100 +1110 7 1099 1116 +1111 5 1103 1104 +1112 9 1103 1107 +1113 9 1103 1108 +1114 5 1104 1105 +1115 5 1104 1106 +1116 4 1104 1109 +1117 9 1105 1110 +1118 9 1105 1111 +1119 9 1105 1112 +1120 9 1106 1113 +1121 9 1106 1114 +1122 9 1106 1115 +1123 11 1116 1117 +1124 12 1116 1120 +1125 3 1117 1118 +1126 4 1117 1121 +1127 14 1117 1122 +1128 6 1118 1119 +1129 7 1118 1132 +1130 5 1122 1123 +1131 5 1122 1124 +1132 4 1122 1125 +1133 9 1123 1126 +1134 9 1123 1127 +1135 9 1123 1128 +1136 9 1124 1129 +1137 9 1124 1130 +1138 9 1124 1131 +1139 11 1132 1133 +1140 12 1132 1136 +1141 3 1133 1134 +1142 4 1133 1137 +1143 5 1133 1138 +1144 6 1134 1135 +1145 7 1134 1151 +1146 5 1138 1139 +1147 9 1138 1142 +1148 9 1138 1143 +1149 5 1139 1140 +1150 5 1139 1141 +1151 4 1139 1144 +1152 9 1140 1145 +1153 9 1140 1146 +1154 9 1140 1147 +1155 9 1141 1148 +1156 9 1141 1149 +1157 9 1141 1150 +1158 11 1151 1152 +1159 12 1151 1155 +1160 3 1152 1153 +1161 4 1152 1156 +1162 5 1152 1157 +1163 6 1153 1154 +1164 7 1153 1175 +1165 8 1157 1158 +1166 9 1157 1164 +1167 9 1157 1165 +1168 8 1158 1159 +1169 9 1158 1166 +1170 9 1158 1167 +1171 35 1159 1160 +1172 9 1159 1168 +1173 9 1159 1169 +1174 36 1160 1161 +1175 37 1160 1170 +1176 36 1161 1162 +1177 36 1161 1163 +1178 37 1162 1171 +1179 37 1162 1172 +1180 37 1163 1173 +1181 37 1163 1174 +1182 11 1175 1176 +1183 12 1175 1179 +1184 3 1176 1177 +1185 4 1176 1180 +1186 5 1176 1181 +1187 6 1177 1178 +1188 7 1177 1194 +1189 5 1181 1182 +1190 9 1181 1185 +1191 9 1181 1186 +1192 5 1182 1183 +1193 5 1182 1184 +1194 4 1182 1187 +1195 9 1183 1188 +1196 9 1183 1189 +1197 9 1183 1190 +1198 9 1184 1191 +1199 9 1184 1192 +1200 9 1184 1193 +1201 11 1194 1195 +1202 12 1194 1198 +1203 3 1195 1196 +1204 4 1195 1199 +1205 5 1195 1200 +1206 6 1196 1197 +1207 7 1196 1218 +1208 8 1200 1201 +1209 9 1200 1207 +1210 9 1200 1208 +1211 8 1201 1202 +1212 9 1201 1209 +1213 9 1201 1210 +1214 35 1202 1203 +1215 9 1202 1211 +1216 9 1202 1212 +1217 36 1203 1204 +1218 37 1203 1213 +1219 36 1204 1205 +1220 36 1204 1206 +1221 37 1205 1214 +1222 37 1205 1215 +1223 37 1206 1216 +1224 37 1206 1217 +1225 22 1218 1219 +1226 12 1218 1222 +1227 23 1219 1220 +1228 24 1219 1223 +1229 24 1219 1224 +1230 6 1220 1221 +1231 7 1220 1225 +1232 22 1225 1226 +1233 12 1225 1229 +1234 47 1226 1227 +1235 24 1226 1230 +1236 24 1226 1231 +1237 26 1227 1228 +1238 26 1227 1232 +1239 48 1233 1234 +1240 48 1233 1235 +1241 48 1236 1237 +1242 48 1236 1238 +1243 48 1239 1240 +1244 48 1239 1241 +1245 48 1242 1243 +1246 48 1242 1244 +1247 48 1245 1246 +1248 48 1245 1247 +1249 48 1248 1249 +1250 48 1248 1250 +1251 48 1251 1252 +1252 48 1251 1253 +1253 48 1254 1255 +1254 48 1254 1256 +1255 48 1257 1258 +1256 48 1257 1259 +1257 48 1260 1261 +1258 48 1260 1262 +1259 48 1263 1264 +1260 48 1263 1265 +1261 48 1266 1267 +1262 48 1266 1268 +1263 48 1269 1270 +1264 48 1269 1271 +1265 48 1272 1273 +1266 48 1272 1274 +1267 48 1275 1276 +1268 48 1275 1277 +1269 48 1278 1279 +1270 48 1278 1280 +1271 48 1281 1282 +1272 48 1281 1283 +1273 48 1284 1285 +1274 48 1284 1286 +1275 48 1287 1288 +1276 48 1287 1289 +1277 48 1290 1291 +1278 48 1290 1292 +1279 48 1293 1294 +1280 48 1293 1295 +1281 48 1296 1297 +1282 48 1296 1298 +1283 48 1299 1300 +1284 48 1299 1301 +1285 48 1302 1303 +1286 48 1302 1304 +1287 48 1305 1306 +1288 48 1305 1307 +1289 48 1308 1309 +1290 48 1308 1310 +1291 48 1311 1312 +1292 48 1311 1313 +1293 48 1314 1315 +1294 48 1314 1316 +1295 48 1317 1318 +1296 48 1317 1319 +1297 48 1320 1321 +1298 48 1320 1322 +1299 48 1323 1324 +1300 48 1323 1325 +1301 48 1326 1327 +1302 48 1326 1328 +1303 48 1329 1330 +1304 48 1329 1331 +1305 48 1332 1333 +1306 48 1332 1334 +1307 48 1335 1336 +1308 48 1335 1337 +1309 48 1338 1339 +1310 48 1338 1340 +1311 48 1341 1342 +1312 48 1341 1343 +1313 48 1344 1345 +1314 48 1344 1346 +1315 48 1347 1348 +1316 48 1347 1349 +1317 48 1350 1351 +1318 48 1350 1352 +1319 48 1353 1354 +1320 48 1353 1355 +1321 48 1356 1357 +1322 48 1356 1358 +1323 48 1359 1360 +1324 48 1359 1361 +1325 48 1362 1363 +1326 48 1362 1364 +1327 48 1365 1366 +1328 48 1365 1367 +1329 48 1368 1369 +1330 48 1368 1370 +1331 48 1371 1372 +1332 48 1371 1373 +1333 48 1374 1375 +1334 48 1374 1376 +1335 48 1377 1378 +1336 48 1377 1379 +1337 48 1380 1381 +1338 48 1380 1382 +1339 48 1383 1384 +1340 48 1383 1385 +1341 48 1386 1387 +1342 48 1386 1388 +1343 48 1389 1390 +1344 48 1389 1391 +1345 48 1392 1393 +1346 48 1392 1394 +1347 48 1395 1396 +1348 48 1395 1397 +1349 48 1398 1399 +1350 48 1398 1400 +1351 48 1401 1402 +1352 48 1401 1403 +1353 48 1404 1405 +1354 48 1404 1406 +1355 48 1407 1408 +1356 48 1407 1409 +1357 48 1410 1411 +1358 48 1410 1412 +1359 48 1413 1414 +1360 48 1413 1415 +1361 48 1416 1417 +1362 48 1416 1418 +1363 48 1419 1420 +1364 48 1419 1421 +1365 48 1422 1423 +1366 48 1422 1424 +1367 48 1425 1426 +1368 48 1425 1427 +1369 48 1428 1429 +1370 48 1428 1430 +1371 48 1431 1432 +1372 48 1431 1433 +1373 48 1434 1435 +1374 48 1434 1436 +1375 48 1437 1438 +1376 48 1437 1439 +1377 48 1440 1441 +1378 48 1440 1442 +1379 48 1443 1444 +1380 48 1443 1445 +1381 48 1446 1447 +1382 48 1446 1448 +1383 48 1449 1450 +1384 48 1449 1451 +1385 48 1452 1453 +1386 48 1452 1454 +1387 48 1455 1456 +1388 48 1455 1457 +1389 48 1458 1459 +1390 48 1458 1460 +1391 48 1461 1462 +1392 48 1461 1463 +1393 48 1464 1465 +1394 48 1464 1466 +1395 48 1467 1468 +1396 48 1467 1469 +1397 48 1470 1471 +1398 48 1470 1472 +1399 48 1473 1474 +1400 48 1473 1475 +1401 48 1476 1477 +1402 48 1476 1478 +1403 48 1479 1480 +1404 48 1479 1481 +1405 48 1482 1483 +1406 48 1482 1484 +1407 48 1485 1486 +1408 48 1485 1487 +1409 48 1488 1489 +1410 48 1488 1490 +1411 48 1491 1492 +1412 48 1491 1493 +1413 48 1494 1495 +1414 48 1494 1496 +1415 48 1497 1498 +1416 48 1497 1499 +1417 48 1500 1501 +1418 48 1500 1502 +1419 48 1503 1504 +1420 48 1503 1505 +1421 48 1506 1507 +1422 48 1506 1508 +1423 48 1509 1510 +1424 48 1509 1511 +1425 48 1512 1513 +1426 48 1512 1514 +1427 48 1515 1516 +1428 48 1515 1517 +1429 48 1518 1519 +1430 48 1518 1520 +1431 48 1521 1522 +1432 48 1521 1523 +1433 48 1524 1525 +1434 48 1524 1526 +1435 48 1527 1528 +1436 48 1527 1529 +1437 48 1530 1531 +1438 48 1530 1532 +1439 48 1533 1534 +1440 48 1533 1535 +1441 48 1536 1537 +1442 48 1536 1538 +1443 48 1539 1540 +1444 48 1539 1541 +1445 48 1542 1543 +1446 48 1542 1544 +1447 48 1545 1546 +1448 48 1545 1547 +1449 48 1548 1549 +1450 48 1548 1550 +1451 48 1551 1552 +1452 48 1551 1553 +1453 48 1554 1555 +1454 48 1554 1556 +1455 48 1557 1558 +1456 48 1557 1559 +1457 48 1560 1561 +1458 48 1560 1562 +1459 48 1563 1564 +1460 48 1563 1565 +1461 48 1566 1567 +1462 48 1566 1568 +1463 48 1569 1570 +1464 48 1569 1571 +1465 48 1572 1573 +1466 48 1572 1574 +1467 48 1575 1576 +1468 48 1575 1577 +1469 48 1578 1579 +1470 48 1578 1580 +1471 48 1581 1582 +1472 48 1581 1583 +1473 48 1584 1585 +1474 48 1584 1586 +1475 48 1587 1588 +1476 48 1587 1589 +1477 48 1590 1591 +1478 48 1590 1592 +1479 48 1593 1594 +1480 48 1593 1595 +1481 48 1596 1597 +1482 48 1596 1598 +1483 48 1599 1600 +1484 48 1599 1601 +1485 48 1602 1603 +1486 48 1602 1604 +1487 48 1605 1606 +1488 48 1605 1607 +1489 48 1608 1609 +1490 48 1608 1610 +1491 48 1611 1612 +1492 48 1611 1613 +1493 48 1614 1615 +1494 48 1614 1616 +1495 48 1617 1618 +1496 48 1617 1619 +1497 48 1620 1621 +1498 48 1620 1622 +1499 48 1623 1624 +1500 48 1623 1625 +1501 48 1626 1627 +1502 48 1626 1628 +1503 48 1629 1630 +1504 48 1629 1631 +1505 48 1632 1633 +1506 48 1632 1634 +1507 48 1635 1636 +1508 48 1635 1637 +1509 48 1638 1639 +1510 48 1638 1640 +1511 48 1641 1642 +1512 48 1641 1643 +1513 48 1644 1645 +1514 48 1644 1646 +1515 48 1647 1648 +1516 48 1647 1649 +1517 48 1650 1651 +1518 48 1650 1652 +1519 48 1653 1654 +1520 48 1653 1655 +1521 48 1656 1657 +1522 48 1656 1658 +1523 48 1659 1660 +1524 48 1659 1661 +1525 48 1662 1663 +1526 48 1662 1664 +1527 48 1665 1666 +1528 48 1665 1667 +1529 48 1668 1669 +1530 48 1668 1670 +1531 48 1671 1672 +1532 48 1671 1673 +1533 48 1674 1675 +1534 48 1674 1676 +1535 48 1677 1678 +1536 48 1677 1679 +1537 48 1680 1681 +1538 48 1680 1682 +1539 48 1683 1684 +1540 48 1683 1685 +1541 48 1686 1687 +1542 48 1686 1688 +1543 48 1689 1690 +1544 48 1689 1691 +1545 48 1692 1693 +1546 48 1692 1694 +1547 48 1695 1696 +1548 48 1695 1697 +1549 48 1698 1699 +1550 48 1698 1700 +1551 48 1701 1702 +1552 48 1701 1703 +1553 48 1704 1705 +1554 48 1704 1706 +1555 48 1707 1708 +1556 48 1707 1709 +1557 48 1710 1711 +1558 48 1710 1712 +1559 48 1713 1714 +1560 48 1713 1715 +1561 48 1716 1717 +1562 48 1716 1718 +1563 48 1719 1720 +1564 48 1719 1721 +1565 48 1722 1723 +1566 48 1722 1724 +1567 48 1725 1726 +1568 48 1725 1727 +1569 48 1728 1729 +1570 48 1728 1730 +1571 48 1731 1732 +1572 48 1731 1733 +1573 48 1734 1735 +1574 48 1734 1736 +1575 48 1737 1738 +1576 48 1737 1739 +1577 48 1740 1741 +1578 48 1740 1742 +1579 48 1743 1744 +1580 48 1743 1745 +1581 48 1746 1747 +1582 48 1746 1748 +1583 48 1749 1750 +1584 48 1749 1751 +1585 48 1752 1753 +1586 48 1752 1754 +1587 48 1755 1756 +1588 48 1755 1757 +1589 48 1758 1759 +1590 48 1758 1760 +1591 48 1761 1762 +1592 48 1761 1763 +1593 48 1764 1765 +1594 48 1764 1766 +1595 48 1767 1768 +1596 48 1767 1769 +1597 48 1770 1771 +1598 48 1770 1772 +1599 48 1773 1774 +1600 48 1773 1775 +1601 48 1776 1777 +1602 48 1776 1778 +1603 48 1779 1780 +1604 48 1779 1781 +1605 48 1782 1783 +1606 48 1782 1784 +1607 48 1785 1786 +1608 48 1785 1787 +1609 48 1788 1789 +1610 48 1788 1790 +1611 48 1791 1792 +1612 48 1791 1793 +1613 48 1794 1795 +1614 48 1794 1796 +1615 48 1797 1798 +1616 48 1797 1799 +1617 48 1800 1801 +1618 48 1800 1802 +1619 48 1803 1804 +1620 48 1803 1805 +1621 48 1806 1807 +1622 48 1806 1808 +1623 48 1809 1810 +1624 48 1809 1811 +1625 48 1812 1813 +1626 48 1812 1814 +1627 48 1815 1816 +1628 48 1815 1817 +1629 48 1818 1819 +1630 48 1818 1820 +1631 48 1821 1822 +1632 48 1821 1823 +1633 48 1824 1825 +1634 48 1824 1826 +1635 48 1827 1828 +1636 48 1827 1829 +1637 48 1830 1831 +1638 48 1830 1832 +1639 48 1833 1834 +1640 48 1833 1835 +1641 48 1836 1837 +1642 48 1836 1838 +1643 48 1839 1840 +1644 48 1839 1841 +1645 48 1842 1843 +1646 48 1842 1844 +1647 48 1845 1846 +1648 48 1845 1847 +1649 48 1848 1849 +1650 48 1848 1850 +1651 48 1851 1852 +1652 48 1851 1853 +1653 48 1854 1855 +1654 48 1854 1856 +1655 48 1857 1858 +1656 48 1857 1859 +1657 48 1860 1861 +1658 48 1860 1862 +1659 48 1863 1864 +1660 48 1863 1865 +1661 48 1866 1867 +1662 48 1866 1868 +1663 48 1869 1870 +1664 48 1869 1871 +1665 48 1872 1873 +1666 48 1872 1874 +1667 48 1875 1876 +1668 48 1875 1877 +1669 48 1878 1879 +1670 48 1878 1880 +1671 48 1881 1882 +1672 48 1881 1883 +1673 48 1884 1885 +1674 48 1884 1886 +1675 48 1887 1888 +1676 48 1887 1889 +1677 48 1890 1891 +1678 48 1890 1892 +1679 48 1893 1894 +1680 48 1893 1895 +1681 48 1896 1897 +1682 48 1896 1898 +1683 48 1899 1900 +1684 48 1899 1901 +1685 48 1902 1903 +1686 48 1902 1904 +1687 48 1905 1906 +1688 48 1905 1907 +1689 48 1908 1909 +1690 48 1908 1910 +1691 48 1911 1912 +1692 48 1911 1913 +1693 48 1914 1915 +1694 48 1914 1916 +1695 48 1917 1918 +1696 48 1917 1919 +1697 48 1920 1921 +1698 48 1920 1922 +1699 48 1923 1924 +1700 48 1923 1925 +1701 48 1926 1927 +1702 48 1926 1928 +1703 48 1929 1930 +1704 48 1929 1931 +1705 48 1932 1933 +1706 48 1932 1934 +1707 48 1935 1936 +1708 48 1935 1937 +1709 48 1938 1939 +1710 48 1938 1940 +1711 48 1941 1942 +1712 48 1941 1943 +1713 48 1944 1945 +1714 48 1944 1946 +1715 48 1947 1948 +1716 48 1947 1949 +1717 48 1950 1951 +1718 48 1950 1952 +1719 48 1953 1954 +1720 48 1953 1955 +1721 48 1956 1957 +1722 48 1956 1958 +1723 48 1959 1960 +1724 48 1959 1961 +1725 48 1962 1963 +1726 48 1962 1964 +1727 48 1965 1966 +1728 48 1965 1967 +1729 48 1968 1969 +1730 48 1968 1970 +1731 48 1971 1972 +1732 48 1971 1973 +1733 48 1974 1975 +1734 48 1974 1976 +1735 48 1977 1978 +1736 48 1977 1979 +1737 48 1980 1981 +1738 48 1980 1982 +1739 48 1983 1984 +1740 48 1983 1985 +1741 48 1986 1987 +1742 48 1986 1988 +1743 48 1989 1990 +1744 48 1989 1991 +1745 48 1992 1993 +1746 48 1992 1994 +1747 48 1995 1996 +1748 48 1995 1997 +1749 48 1998 1999 +1750 48 1998 2000 +1751 48 2001 2002 +1752 48 2001 2003 +1753 48 2004 2005 +1754 48 2004 2006 +1755 48 2007 2008 +1756 48 2007 2009 +1757 48 2010 2011 +1758 48 2010 2012 +1759 48 2013 2014 +1760 48 2013 2015 +1761 48 2016 2017 +1762 48 2016 2018 +1763 48 2019 2020 +1764 48 2019 2021 +1765 48 2022 2023 +1766 48 2022 2024 +1767 48 2025 2026 +1768 48 2025 2027 +1769 48 2028 2029 +1770 48 2028 2030 +1771 48 2031 2032 +1772 48 2031 2033 +1773 48 2034 2035 +1774 48 2034 2036 +1775 48 2037 2038 +1776 48 2037 2039 +1777 48 2040 2041 +1778 48 2040 2042 +1779 48 2043 2044 +1780 48 2043 2045 +1781 48 2046 2047 +1782 48 2046 2048 +1783 48 2049 2050 +1784 48 2049 2051 +1785 48 2052 2053 +1786 48 2052 2054 +1787 48 2055 2056 +1788 48 2055 2057 +1789 48 2058 2059 +1790 48 2058 2060 +1791 48 2061 2062 +1792 48 2061 2063 +1793 48 2064 2065 +1794 48 2064 2066 +1795 48 2067 2068 +1796 48 2067 2069 +1797 48 2070 2071 +1798 48 2070 2072 +1799 48 2073 2074 +1800 48 2073 2075 +1801 48 2076 2077 +1802 48 2076 2078 +1803 48 2079 2080 +1804 48 2079 2081 +1805 48 2082 2083 +1806 48 2082 2084 +1807 48 2085 2086 +1808 48 2085 2087 +1809 48 2088 2089 +1810 48 2088 2090 +1811 48 2091 2092 +1812 48 2091 2093 +1813 48 2094 2095 +1814 48 2094 2096 +1815 48 2097 2098 +1816 48 2097 2099 +1817 48 2100 2101 +1818 48 2100 2102 +1819 48 2103 2104 +1820 48 2103 2105 +1821 48 2106 2107 +1822 48 2106 2108 +1823 48 2109 2110 +1824 48 2109 2111 +1825 48 2112 2113 +1826 48 2112 2114 +1827 48 2115 2116 +1828 48 2115 2117 +1829 48 2118 2119 +1830 48 2118 2120 +1831 48 2121 2122 +1832 48 2121 2123 +1833 48 2124 2125 +1834 48 2124 2126 +1835 48 2127 2128 +1836 48 2127 2129 +1837 48 2130 2131 +1838 48 2130 2132 +1839 48 2133 2134 +1840 48 2133 2135 +1841 48 2136 2137 +1842 48 2136 2138 +1843 48 2139 2140 +1844 48 2139 2141 +1845 48 2142 2143 +1846 48 2142 2144 +1847 48 2145 2146 +1848 48 2145 2147 +1849 48 2148 2149 +1850 48 2148 2150 +1851 48 2151 2152 +1852 48 2151 2153 +1853 48 2154 2155 +1854 48 2154 2156 +1855 48 2157 2158 +1856 48 2157 2159 +1857 48 2160 2161 +1858 48 2160 2162 +1859 48 2163 2164 +1860 48 2163 2165 +1861 48 2166 2167 +1862 48 2166 2168 +1863 48 2169 2170 +1864 48 2169 2171 +1865 48 2172 2173 +1866 48 2172 2174 +1867 48 2175 2176 +1868 48 2175 2177 +1869 48 2178 2179 +1870 48 2178 2180 +1871 48 2181 2182 +1872 48 2181 2183 +1873 48 2184 2185 +1874 48 2184 2186 +1875 48 2187 2188 +1876 48 2187 2189 +1877 48 2190 2191 +1878 48 2190 2192 +1879 48 2193 2194 +1880 48 2193 2195 +1881 48 2196 2197 +1882 48 2196 2198 +1883 48 2199 2200 +1884 48 2199 2201 +1885 48 2202 2203 +1886 48 2202 2204 +1887 48 2205 2206 +1888 48 2205 2207 +1889 48 2208 2209 +1890 48 2208 2210 +1891 48 2211 2212 +1892 48 2211 2213 +1893 48 2214 2215 +1894 48 2214 2216 +1895 48 2217 2218 +1896 48 2217 2219 +1897 48 2220 2221 +1898 48 2220 2222 +1899 48 2223 2224 +1900 48 2223 2225 +1901 48 2226 2227 +1902 48 2226 2228 +1903 48 2229 2230 +1904 48 2229 2231 +1905 48 2232 2233 +1906 48 2232 2234 +1907 48 2235 2236 +1908 48 2235 2237 +1909 48 2238 2239 +1910 48 2238 2240 +1911 48 2241 2242 +1912 48 2241 2243 +1913 48 2244 2245 +1914 48 2244 2246 +1915 48 2247 2248 +1916 48 2247 2249 +1917 48 2250 2251 +1918 48 2250 2252 +1919 48 2253 2254 +1920 48 2253 2255 +1921 48 2256 2257 +1922 48 2256 2258 +1923 48 2259 2260 +1924 48 2259 2261 +1925 48 2262 2263 +1926 48 2262 2264 +1927 48 2265 2266 +1928 48 2265 2267 +1929 48 2268 2269 +1930 48 2268 2270 +1931 48 2271 2272 +1932 48 2271 2273 +1933 48 2274 2275 +1934 48 2274 2276 +1935 48 2277 2278 +1936 48 2277 2279 +1937 48 2280 2281 +1938 48 2280 2282 +1939 48 2283 2284 +1940 48 2283 2285 +1941 48 2286 2287 +1942 48 2286 2288 +1943 48 2289 2290 +1944 48 2289 2291 +1945 48 2292 2293 +1946 48 2292 2294 +1947 48 2295 2296 +1948 48 2295 2297 +1949 48 2298 2299 +1950 48 2298 2300 +1951 48 2301 2302 +1952 48 2301 2303 +1953 48 2304 2305 +1954 48 2304 2306 +1955 48 2307 2308 +1956 48 2307 2309 +1957 48 2310 2311 +1958 48 2310 2312 +1959 48 2313 2314 +1960 48 2313 2315 +1961 48 2316 2317 +1962 48 2316 2318 +1963 48 2319 2320 +1964 48 2319 2321 +1965 48 2322 2323 +1966 48 2322 2324 +1967 48 2325 2326 +1968 48 2325 2327 +1969 48 2328 2329 +1970 48 2328 2330 +1971 48 2331 2332 +1972 48 2331 2333 +1973 48 2334 2335 +1974 48 2334 2336 +1975 48 2337 2338 +1976 48 2337 2339 +1977 48 2340 2341 +1978 48 2340 2342 +1979 48 2343 2344 +1980 48 2343 2345 +1981 48 2346 2347 +1982 48 2346 2348 +1983 48 2349 2350 +1984 48 2349 2351 +1985 48 2352 2353 +1986 48 2352 2354 +1987 48 2355 2356 +1988 48 2355 2357 +1989 48 2358 2359 +1990 48 2358 2360 +1991 48 2361 2362 +1992 48 2361 2363 +1993 48 2364 2365 +1994 48 2364 2366 +1995 48 2367 2368 +1996 48 2367 2369 +1997 48 2370 2371 +1998 48 2370 2372 +1999 48 2373 2374 +2000 48 2373 2375 +2001 48 2376 2377 +2002 48 2376 2378 +2003 48 2379 2380 +2004 48 2379 2381 +2005 48 2382 2383 +2006 48 2382 2384 +2007 48 2385 2386 +2008 48 2385 2387 +2009 48 2388 2389 +2010 48 2388 2390 +2011 48 2391 2392 +2012 48 2391 2393 +2013 48 2394 2395 +2014 48 2394 2396 +2015 48 2397 2398 +2016 48 2397 2399 +2017 48 2400 2401 +2018 48 2400 2402 +2019 48 2403 2404 +2020 48 2403 2405 +2021 48 2406 2407 +2022 48 2406 2408 +2023 48 2409 2410 +2024 48 2409 2411 +2025 48 2412 2413 +2026 48 2412 2414 +2027 48 2415 2416 +2028 48 2415 2417 +2029 48 2418 2419 +2030 48 2418 2420 +2031 48 2421 2422 +2032 48 2421 2423 +2033 48 2424 2425 +2034 48 2424 2426 +2035 48 2427 2428 +2036 48 2427 2429 +2037 48 2430 2431 +2038 48 2430 2432 +2039 48 2433 2434 +2040 48 2433 2435 +2041 48 2436 2437 +2042 48 2436 2438 +2043 48 2439 2440 +2044 48 2439 2441 +2045 48 2442 2443 +2046 48 2442 2444 +2047 48 2445 2446 +2048 48 2445 2447 +2049 48 2448 2449 +2050 48 2448 2450 +2051 48 2451 2452 +2052 48 2451 2453 +2053 48 2454 2455 +2054 48 2454 2456 +2055 48 2457 2458 +2056 48 2457 2459 +2057 48 2460 2461 +2058 48 2460 2462 +2059 48 2463 2464 +2060 48 2463 2465 +2061 48 2466 2467 +2062 48 2466 2468 +2063 48 2469 2470 +2064 48 2469 2471 +2065 48 2472 2473 +2066 48 2472 2474 +2067 48 2475 2476 +2068 48 2475 2477 +2069 48 2478 2479 +2070 48 2478 2480 +2071 48 2481 2482 +2072 48 2481 2483 +2073 48 2484 2485 +2074 48 2484 2486 +2075 48 2487 2488 +2076 48 2487 2489 +2077 48 2490 2491 +2078 48 2490 2492 +2079 48 2493 2494 +2080 48 2493 2495 +2081 48 2496 2497 +2082 48 2496 2498 +2083 48 2499 2500 +2084 48 2499 2501 +2085 48 2502 2503 +2086 48 2502 2504 +2087 48 2505 2506 +2088 48 2505 2507 +2089 48 2508 2509 +2090 48 2508 2510 +2091 48 2511 2512 +2092 48 2511 2513 +2093 48 2514 2515 +2094 48 2514 2516 +2095 48 2517 2518 +2096 48 2517 2519 +2097 48 2520 2521 +2098 48 2520 2522 +2099 48 2523 2524 +2100 48 2523 2525 +2101 48 2526 2527 +2102 48 2526 2528 +2103 48 2529 2530 +2104 48 2529 2531 +2105 48 2532 2533 +2106 48 2532 2534 +2107 48 2535 2536 +2108 48 2535 2537 +2109 48 2538 2539 +2110 48 2538 2540 +2111 48 2541 2542 +2112 48 2541 2543 +2113 48 2544 2545 +2114 48 2544 2546 +2115 48 2547 2548 +2116 48 2547 2549 +2117 48 2550 2551 +2118 48 2550 2552 +2119 48 2553 2554 +2120 48 2553 2555 +2121 48 2556 2557 +2122 48 2556 2558 +2123 48 2559 2560 +2124 48 2559 2561 +2125 48 2562 2563 +2126 48 2562 2564 +2127 48 2565 2566 +2128 48 2565 2567 +2129 48 2568 2569 +2130 48 2568 2570 +2131 48 2571 2572 +2132 48 2571 2573 +2133 48 2574 2575 +2134 48 2574 2576 +2135 48 2577 2578 +2136 48 2577 2579 +2137 48 2580 2581 +2138 48 2580 2582 +2139 48 2583 2584 +2140 48 2583 2585 +2141 48 2586 2587 +2142 48 2586 2588 +2143 48 2589 2590 +2144 48 2589 2591 +2145 48 2592 2593 +2146 48 2592 2594 +2147 48 2595 2596 +2148 48 2595 2597 +2149 48 2598 2599 +2150 48 2598 2600 +2151 48 2601 2602 +2152 48 2601 2603 +2153 48 2604 2605 +2154 48 2604 2606 +2155 48 2607 2608 +2156 48 2607 2609 +2157 48 2610 2611 +2158 48 2610 2612 +2159 48 2613 2614 +2160 48 2613 2615 +2161 48 2616 2617 +2162 48 2616 2618 +2163 48 2619 2620 +2164 48 2619 2621 +2165 48 2622 2623 +2166 48 2622 2624 +2167 48 2625 2626 +2168 48 2625 2627 +2169 48 2628 2629 +2170 48 2628 2630 +2171 48 2631 2632 +2172 48 2631 2633 +2173 48 2634 2635 +2174 48 2634 2636 +2175 48 2637 2638 +2176 48 2637 2639 +2177 48 2640 2641 +2178 48 2640 2642 +2179 48 2643 2644 +2180 48 2643 2645 +2181 48 2646 2647 +2182 48 2646 2648 +2183 48 2649 2650 +2184 48 2649 2651 +2185 48 2652 2653 +2186 48 2652 2654 +2187 48 2655 2656 +2188 48 2655 2657 +2189 48 2658 2659 +2190 48 2658 2660 +2191 48 2661 2662 +2192 48 2661 2663 +2193 48 2664 2665 +2194 48 2664 2666 +2195 48 2667 2668 +2196 48 2667 2669 +2197 48 2670 2671 +2198 48 2670 2672 +2199 48 2673 2674 +2200 48 2673 2675 +2201 48 2676 2677 +2202 48 2676 2678 +2203 48 2679 2680 +2204 48 2679 2681 +2205 48 2682 2683 +2206 48 2682 2684 +2207 48 2685 2686 +2208 48 2685 2687 +2209 48 2688 2689 +2210 48 2688 2690 +2211 48 2691 2692 +2212 48 2691 2693 +2213 48 2694 2695 +2214 48 2694 2696 +2215 48 2697 2698 +2216 48 2697 2699 +2217 48 2700 2701 +2218 48 2700 2702 +2219 48 2703 2704 +2220 48 2703 2705 +2221 48 2706 2707 +2222 48 2706 2708 +2223 48 2709 2710 +2224 48 2709 2711 +2225 48 2712 2713 +2226 48 2712 2714 +2227 48 2715 2716 +2228 48 2715 2717 +2229 48 2718 2719 +2230 48 2718 2720 +2231 48 2721 2722 +2232 48 2721 2723 +2233 48 2724 2725 +2234 48 2724 2726 +2235 48 2727 2728 +2236 48 2727 2729 +2237 48 2730 2731 +2238 48 2730 2732 +2239 48 2733 2734 +2240 48 2733 2735 +2241 48 2736 2737 +2242 48 2736 2738 +2243 48 2739 2740 +2244 48 2739 2741 +2245 48 2742 2743 +2246 48 2742 2744 +2247 48 2745 2746 +2248 48 2745 2747 +2249 48 2748 2749 +2250 48 2748 2750 +2251 48 2751 2752 +2252 48 2751 2753 +2253 48 2754 2755 +2254 48 2754 2756 +2255 48 2757 2758 +2256 48 2757 2759 +2257 48 2760 2761 +2258 48 2760 2762 +2259 48 2763 2764 +2260 48 2763 2765 +2261 48 2766 2767 +2262 48 2766 2768 +2263 48 2769 2770 +2264 48 2769 2771 +2265 48 2772 2773 +2266 48 2772 2774 +2267 48 2775 2776 +2268 48 2775 2777 +2269 48 2778 2779 +2270 48 2778 2780 +2271 48 2781 2782 +2272 48 2781 2783 +2273 48 2784 2785 +2274 48 2784 2786 +2275 48 2787 2788 +2276 48 2787 2789 +2277 48 2790 2791 +2278 48 2790 2792 +2279 48 2793 2794 +2280 48 2793 2795 +2281 48 2796 2797 +2282 48 2796 2798 +2283 48 2799 2800 +2284 48 2799 2801 +2285 48 2802 2803 +2286 48 2802 2804 +2287 48 2805 2806 +2288 48 2805 2807 +2289 48 2808 2809 +2290 48 2808 2810 +2291 48 2811 2812 +2292 48 2811 2813 +2293 48 2814 2815 +2294 48 2814 2816 +2295 48 2817 2818 +2296 48 2817 2819 +2297 48 2820 2821 +2298 48 2820 2822 +2299 48 2823 2824 +2300 48 2823 2825 +2301 48 2826 2827 +2302 48 2826 2828 +2303 48 2829 2830 +2304 48 2829 2831 +2305 48 2832 2833 +2306 48 2832 2834 +2307 48 2835 2836 +2308 48 2835 2837 +2309 48 2838 2839 +2310 48 2838 2840 +2311 48 2841 2842 +2312 48 2841 2843 +2313 48 2844 2845 +2314 48 2844 2846 +2315 48 2847 2848 +2316 48 2847 2849 +2317 48 2850 2851 +2318 48 2850 2852 +2319 48 2853 2854 +2320 48 2853 2855 +2321 48 2856 2857 +2322 48 2856 2858 +2323 48 2859 2860 +2324 48 2859 2861 +2325 48 2862 2863 +2326 48 2862 2864 +2327 48 2865 2866 +2328 48 2865 2867 +2329 48 2868 2869 +2330 48 2868 2870 +2331 48 2871 2872 +2332 48 2871 2873 +2333 48 2874 2875 +2334 48 2874 2876 +2335 48 2877 2878 +2336 48 2877 2879 +2337 48 2880 2881 +2338 48 2880 2882 +2339 48 2883 2884 +2340 48 2883 2885 +2341 48 2886 2887 +2342 48 2886 2888 +2343 48 2889 2890 +2344 48 2889 2891 +2345 48 2892 2893 +2346 48 2892 2894 +2347 48 2895 2896 +2348 48 2895 2897 +2349 48 2898 2899 +2350 48 2898 2900 +2351 48 2901 2902 +2352 48 2901 2903 +2353 48 2904 2905 +2354 48 2904 2906 +2355 48 2907 2908 +2356 48 2907 2909 +2357 48 2910 2911 +2358 48 2910 2912 +2359 48 2913 2914 +2360 48 2913 2915 +2361 48 2916 2917 +2362 48 2916 2918 +2363 48 2919 2920 +2364 48 2919 2921 +2365 48 2922 2923 +2366 48 2922 2924 +2367 48 2925 2926 +2368 48 2925 2927 +2369 48 2928 2929 +2370 48 2928 2930 +2371 48 2931 2932 +2372 48 2931 2933 +2373 48 2934 2935 +2374 48 2934 2936 +2375 48 2937 2938 +2376 48 2937 2939 +2377 48 2940 2941 +2378 48 2940 2942 +2379 48 2943 2944 +2380 48 2943 2945 +2381 48 2946 2947 +2382 48 2946 2948 +2383 48 2949 2950 +2384 48 2949 2951 +2385 48 2952 2953 +2386 48 2952 2954 +2387 48 2955 2956 +2388 48 2955 2957 +2389 48 2958 2959 +2390 48 2958 2960 +2391 48 2961 2962 +2392 48 2961 2963 +2393 48 2964 2965 +2394 48 2964 2966 +2395 48 2967 2968 +2396 48 2967 2969 +2397 48 2970 2971 +2398 48 2970 2972 +2399 48 2973 2974 +2400 48 2973 2975 +2401 48 2976 2977 +2402 48 2976 2978 +2403 48 2979 2980 +2404 48 2979 2981 +2405 48 2982 2983 +2406 48 2982 2984 +2407 48 2985 2986 +2408 48 2985 2987 +2409 48 2988 2989 +2410 48 2988 2990 +2411 48 2991 2992 +2412 48 2991 2993 +2413 48 2994 2995 +2414 48 2994 2996 +2415 48 2997 2998 +2416 48 2997 2999 +2417 48 3000 3001 +2418 48 3000 3002 +2419 48 3003 3004 +2420 48 3003 3005 +2421 48 3006 3007 +2422 48 3006 3008 +2423 48 3009 3010 +2424 48 3009 3011 +2425 48 3012 3013 +2426 48 3012 3014 +2427 48 3015 3016 +2428 48 3015 3017 +2429 48 3018 3019 +2430 48 3018 3020 +2431 48 3021 3022 +2432 48 3021 3023 +2433 48 3024 3025 +2434 48 3024 3026 +2435 48 3027 3028 +2436 48 3027 3029 +2437 48 3030 3031 +2438 48 3030 3032 +2439 48 3033 3034 +2440 48 3033 3035 +2441 48 3036 3037 +2442 48 3036 3038 +2443 48 3039 3040 +2444 48 3039 3041 +2445 48 3042 3043 +2446 48 3042 3044 +2447 48 3045 3046 +2448 48 3045 3047 +2449 48 3048 3049 +2450 48 3048 3050 +2451 48 3051 3052 +2452 48 3051 3053 +2453 48 3054 3055 +2454 48 3054 3056 +2455 48 3057 3058 +2456 48 3057 3059 +2457 48 3060 3061 +2458 48 3060 3062 +2459 48 3063 3064 +2460 48 3063 3065 +2461 48 3066 3067 +2462 48 3066 3068 +2463 48 3069 3070 +2464 48 3069 3071 +2465 48 3072 3073 +2466 48 3072 3074 +2467 48 3075 3076 +2468 48 3075 3077 +2469 48 3078 3079 +2470 48 3078 3080 +2471 48 3081 3082 +2472 48 3081 3083 +2473 48 3084 3085 +2474 48 3084 3086 +2475 48 3087 3088 +2476 48 3087 3089 +2477 48 3090 3091 +2478 48 3090 3092 +2479 48 3093 3094 +2480 48 3093 3095 +2481 48 3096 3097 +2482 48 3096 3098 +2483 48 3099 3100 +2484 48 3099 3101 +2485 48 3102 3103 +2486 48 3102 3104 +2487 48 3105 3106 +2488 48 3105 3107 +2489 48 3108 3109 +2490 48 3108 3110 +2491 48 3111 3112 +2492 48 3111 3113 +2493 48 3114 3115 +2494 48 3114 3116 +2495 48 3117 3118 +2496 48 3117 3119 +2497 48 3120 3121 +2498 48 3120 3122 +2499 48 3123 3124 +2500 48 3123 3125 +2501 48 3126 3127 +2502 48 3126 3128 +2503 48 3129 3130 +2504 48 3129 3131 +2505 48 3132 3133 +2506 48 3132 3134 +2507 48 3135 3136 +2508 48 3135 3137 +2509 48 3138 3139 +2510 48 3138 3140 +2511 48 3141 3142 +2512 48 3141 3143 +2513 48 3144 3145 +2514 48 3144 3146 +2515 48 3147 3148 +2516 48 3147 3149 +2517 48 3150 3151 +2518 48 3150 3152 +2519 48 3153 3154 +2520 48 3153 3155 +2521 48 3156 3157 +2522 48 3156 3158 +2523 48 3159 3160 +2524 48 3159 3161 +2525 48 3162 3163 +2526 48 3162 3164 +2527 48 3165 3166 +2528 48 3165 3167 +2529 48 3168 3169 +2530 48 3168 3170 +2531 48 3171 3172 +2532 48 3171 3173 +2533 48 3174 3175 +2534 48 3174 3176 +2535 48 3177 3178 +2536 48 3177 3179 +2537 48 3180 3181 +2538 48 3180 3182 +2539 48 3183 3184 +2540 48 3183 3185 +2541 48 3186 3187 +2542 48 3186 3188 +2543 48 3189 3190 +2544 48 3189 3191 +2545 48 3192 3193 +2546 48 3192 3194 +2547 48 3195 3196 +2548 48 3195 3197 +2549 48 3198 3199 +2550 48 3198 3200 +2551 48 3201 3202 +2552 48 3201 3203 +2553 48 3204 3205 +2554 48 3204 3206 +2555 48 3207 3208 +2556 48 3207 3209 +2557 48 3210 3211 +2558 48 3210 3212 +2559 48 3213 3214 +2560 48 3213 3215 +2561 48 3216 3217 +2562 48 3216 3218 +2563 48 3219 3220 +2564 48 3219 3221 +2565 48 3222 3223 +2566 48 3222 3224 +2567 48 3225 3226 +2568 48 3225 3227 +2569 48 3228 3229 +2570 48 3228 3230 +2571 48 3231 3232 +2572 48 3231 3233 +2573 48 3234 3235 +2574 48 3234 3236 +2575 48 3237 3238 +2576 48 3237 3239 +2577 48 3240 3241 +2578 48 3240 3242 +2579 48 3243 3244 +2580 48 3243 3245 +2581 48 3246 3247 +2582 48 3246 3248 +2583 48 3249 3250 +2584 48 3249 3251 +2585 48 3252 3253 +2586 48 3252 3254 +2587 48 3255 3256 +2588 48 3255 3257 +2589 48 3258 3259 +2590 48 3258 3260 +2591 48 3261 3262 +2592 48 3261 3263 +2593 48 3264 3265 +2594 48 3264 3266 +2595 48 3267 3268 +2596 48 3267 3269 +2597 48 3270 3271 +2598 48 3270 3272 +2599 48 3273 3274 +2600 48 3273 3275 +2601 48 3276 3277 +2602 48 3276 3278 +2603 48 3279 3280 +2604 48 3279 3281 +2605 48 3282 3283 +2606 48 3282 3284 +2607 48 3285 3286 +2608 48 3285 3287 +2609 48 3288 3289 +2610 48 3288 3290 +2611 48 3291 3292 +2612 48 3291 3293 +2613 48 3294 3295 +2614 48 3294 3296 +2615 48 3297 3298 +2616 48 3297 3299 +2617 48 3300 3301 +2618 48 3300 3302 +2619 48 3303 3304 +2620 48 3303 3305 +2621 48 3306 3307 +2622 48 3306 3308 +2623 48 3309 3310 +2624 48 3309 3311 +2625 48 3312 3313 +2626 48 3312 3314 +2627 48 3315 3316 +2628 48 3315 3317 +2629 48 3318 3319 +2630 48 3318 3320 +2631 48 3321 3322 +2632 48 3321 3323 +2633 48 3324 3325 +2634 48 3324 3326 +2635 48 3327 3328 +2636 48 3327 3329 +2637 48 3330 3331 +2638 48 3330 3332 +2639 48 3333 3334 +2640 48 3333 3335 +2641 48 3336 3337 +2642 48 3336 3338 +2643 48 3339 3340 +2644 48 3339 3341 +2645 48 3342 3343 +2646 48 3342 3344 +2647 48 3345 3346 +2648 48 3345 3347 +2649 48 3348 3349 +2650 48 3348 3350 +2651 48 3351 3352 +2652 48 3351 3353 +2653 48 3354 3355 +2654 48 3354 3356 +2655 48 3357 3358 +2656 48 3357 3359 +2657 48 3360 3361 +2658 48 3360 3362 +2659 48 3363 3364 +2660 48 3363 3365 +2661 48 3366 3367 +2662 48 3366 3368 +2663 48 3369 3370 +2664 48 3369 3371 +2665 48 3372 3373 +2666 48 3372 3374 +2667 48 3375 3376 +2668 48 3375 3377 +2669 48 3378 3379 +2670 48 3378 3380 +2671 48 3381 3382 +2672 48 3381 3383 +2673 48 3384 3385 +2674 48 3384 3386 +2675 48 3387 3388 +2676 48 3387 3389 +2677 48 3390 3391 +2678 48 3390 3392 +2679 48 3393 3394 +2680 48 3393 3395 +2681 48 3396 3397 +2682 48 3396 3398 +2683 48 3399 3400 +2684 48 3399 3401 +2685 48 3402 3403 +2686 48 3402 3404 +2687 48 3405 3406 +2688 48 3405 3407 +2689 48 3408 3409 +2690 48 3408 3410 +2691 48 3411 3412 +2692 48 3411 3413 +2693 48 3414 3415 +2694 48 3414 3416 +2695 48 3417 3418 +2696 48 3417 3419 +2697 48 3420 3421 +2698 48 3420 3422 +2699 48 3423 3424 +2700 48 3423 3425 +2701 48 3426 3427 +2702 48 3426 3428 +2703 48 3429 3430 +2704 48 3429 3431 +2705 48 3432 3433 +2706 48 3432 3434 +2707 48 3435 3436 +2708 48 3435 3437 +2709 48 3438 3439 +2710 48 3438 3440 +2711 48 3441 3442 +2712 48 3441 3443 +2713 48 3444 3445 +2714 48 3444 3446 +2715 48 3447 3448 +2716 48 3447 3449 +2717 48 3450 3451 +2718 48 3450 3452 +2719 48 3453 3454 +2720 48 3453 3455 +2721 48 3456 3457 +2722 48 3456 3458 +2723 48 3459 3460 +2724 48 3459 3461 +2725 48 3462 3463 +2726 48 3462 3464 +2727 48 3465 3466 +2728 48 3465 3467 +2729 48 3468 3469 +2730 48 3468 3470 +2731 48 3471 3472 +2732 48 3471 3473 +2733 48 3474 3475 +2734 48 3474 3476 +2735 48 3477 3478 +2736 48 3477 3479 +2737 48 3480 3481 +2738 48 3480 3482 +2739 48 3483 3484 +2740 48 3483 3485 +2741 48 3486 3487 +2742 48 3486 3488 +2743 48 3489 3490 +2744 48 3489 3491 +2745 48 3492 3493 +2746 48 3492 3494 +2747 48 3495 3496 +2748 48 3495 3497 +2749 48 3498 3499 +2750 48 3498 3500 +2751 48 3501 3502 +2752 48 3501 3503 +2753 48 3504 3505 +2754 48 3504 3506 +2755 48 3507 3508 +2756 48 3507 3509 +2757 48 3510 3511 +2758 48 3510 3512 +2759 48 3513 3514 +2760 48 3513 3515 +2761 48 3516 3517 +2762 48 3516 3518 +2763 48 3519 3520 +2764 48 3519 3521 +2765 48 3522 3523 +2766 48 3522 3524 +2767 48 3525 3526 +2768 48 3525 3527 +2769 48 3528 3529 +2770 48 3528 3530 +2771 48 3531 3532 +2772 48 3531 3533 +2773 48 3534 3535 +2774 48 3534 3536 +2775 48 3537 3538 +2776 48 3537 3539 +2777 48 3540 3541 +2778 48 3540 3542 +2779 48 3543 3544 +2780 48 3543 3545 +2781 48 3546 3547 +2782 48 3546 3548 +2783 48 3549 3550 +2784 48 3549 3551 +2785 48 3552 3553 +2786 48 3552 3554 +2787 48 3555 3556 +2788 48 3555 3557 +2789 48 3558 3559 +2790 48 3558 3560 +2791 48 3561 3562 +2792 48 3561 3563 +2793 48 3564 3565 +2794 48 3564 3566 +2795 48 3567 3568 +2796 48 3567 3569 +2797 48 3570 3571 +2798 48 3570 3572 +2799 48 3573 3574 +2800 48 3573 3575 +2801 48 3576 3577 +2802 48 3576 3578 +2803 48 3579 3580 +2804 48 3579 3581 +2805 48 3582 3583 +2806 48 3582 3584 +2807 48 3585 3586 +2808 48 3585 3587 +2809 48 3588 3589 +2810 48 3588 3590 +2811 48 3591 3592 +2812 48 3591 3593 +2813 48 3594 3595 +2814 48 3594 3596 +2815 48 3597 3598 +2816 48 3597 3599 +2817 48 3600 3601 +2818 48 3600 3602 +2819 48 3603 3604 +2820 48 3603 3605 +2821 48 3606 3607 +2822 48 3606 3608 +2823 48 3609 3610 +2824 48 3609 3611 +2825 48 3612 3613 +2826 48 3612 3614 +2827 48 3615 3616 +2828 48 3615 3617 +2829 48 3618 3619 +2830 48 3618 3620 +2831 48 3621 3622 +2832 48 3621 3623 +2833 48 3624 3625 +2834 48 3624 3626 +2835 48 3627 3628 +2836 48 3627 3629 +2837 48 3630 3631 +2838 48 3630 3632 +2839 48 3633 3634 +2840 48 3633 3635 +2841 48 3636 3637 +2842 48 3636 3638 +2843 48 3639 3640 +2844 48 3639 3641 +2845 48 3642 3643 +2846 48 3642 3644 +2847 48 3645 3646 +2848 48 3645 3647 +2849 48 3648 3649 +2850 48 3648 3650 +2851 48 3651 3652 +2852 48 3651 3653 +2853 48 3654 3655 +2854 48 3654 3656 +2855 48 3657 3658 +2856 48 3657 3659 +2857 48 3660 3661 +2858 48 3660 3662 +2859 48 3663 3664 +2860 48 3663 3665 +2861 48 3666 3667 +2862 48 3666 3668 +2863 48 3669 3670 +2864 48 3669 3671 +2865 48 3672 3673 +2866 48 3672 3674 +2867 48 3675 3676 +2868 48 3675 3677 +2869 48 3678 3679 +2870 48 3678 3680 +2871 48 3681 3682 +2872 48 3681 3683 +2873 48 3684 3685 +2874 48 3684 3686 +2875 48 3687 3688 +2876 48 3687 3689 +2877 48 3690 3691 +2878 48 3690 3692 +2879 48 3693 3694 +2880 48 3693 3695 +2881 48 3696 3697 +2882 48 3696 3698 +2883 48 3699 3700 +2884 48 3699 3701 +2885 48 3702 3703 +2886 48 3702 3704 +2887 48 3705 3706 +2888 48 3705 3707 +2889 48 3708 3709 +2890 48 3708 3710 +2891 48 3711 3712 +2892 48 3711 3713 +2893 48 3714 3715 +2894 48 3714 3716 +2895 48 3717 3718 +2896 48 3717 3719 +2897 48 3720 3721 +2898 48 3720 3722 +2899 48 3723 3724 +2900 48 3723 3725 +2901 48 3726 3727 +2902 48 3726 3728 +2903 48 3729 3730 +2904 48 3729 3731 +2905 48 3732 3733 +2906 48 3732 3734 +2907 48 3735 3736 +2908 48 3735 3737 +2909 48 3738 3739 +2910 48 3738 3740 +2911 48 3741 3742 +2912 48 3741 3743 +2913 48 3744 3745 +2914 48 3744 3746 +2915 48 3747 3748 +2916 48 3747 3749 +2917 48 3750 3751 +2918 48 3750 3752 +2919 48 3753 3754 +2920 48 3753 3755 +2921 48 3756 3757 +2922 48 3756 3758 +2923 48 3759 3760 +2924 48 3759 3761 +2925 48 3762 3763 +2926 48 3762 3764 +2927 48 3765 3766 +2928 48 3765 3767 +2929 48 3768 3769 +2930 48 3768 3770 +2931 48 3771 3772 +2932 48 3771 3773 +2933 48 3774 3775 +2934 48 3774 3776 +2935 48 3777 3778 +2936 48 3777 3779 +2937 48 3780 3781 +2938 48 3780 3782 +2939 48 3783 3784 +2940 48 3783 3785 +2941 48 3786 3787 +2942 48 3786 3788 +2943 48 3789 3790 +2944 48 3789 3791 +2945 48 3792 3793 +2946 48 3792 3794 +2947 48 3795 3796 +2948 48 3795 3797 +2949 48 3798 3799 +2950 48 3798 3800 +2951 48 3801 3802 +2952 48 3801 3803 +2953 48 3804 3805 +2954 48 3804 3806 +2955 48 3807 3808 +2956 48 3807 3809 +2957 48 3810 3811 +2958 48 3810 3812 +2959 48 3813 3814 +2960 48 3813 3815 +2961 48 3816 3817 +2962 48 3816 3818 +2963 48 3819 3820 +2964 48 3819 3821 +2965 48 3822 3823 +2966 48 3822 3824 +2967 48 3825 3826 +2968 48 3825 3827 +2969 48 3828 3829 +2970 48 3828 3830 +2971 48 3831 3832 +2972 48 3831 3833 +2973 48 3834 3835 +2974 48 3834 3836 +2975 48 3837 3838 +2976 48 3837 3839 +2977 48 3840 3841 +2978 48 3840 3842 +2979 48 3843 3844 +2980 48 3843 3845 +2981 48 3846 3847 +2982 48 3846 3848 +2983 48 3849 3850 +2984 48 3849 3851 +2985 48 3852 3853 +2986 48 3852 3854 +2987 48 3855 3856 +2988 48 3855 3857 +2989 48 3858 3859 +2990 48 3858 3860 +2991 48 3861 3862 +2992 48 3861 3863 +2993 48 3864 3865 +2994 48 3864 3866 +2995 48 3867 3868 +2996 48 3867 3869 +2997 48 3870 3871 +2998 48 3870 3872 +2999 48 3873 3874 +3000 48 3873 3875 +3001 48 3876 3877 +3002 48 3876 3878 +3003 48 3879 3880 +3004 48 3879 3881 +3005 48 3882 3883 +3006 48 3882 3884 +3007 48 3885 3886 +3008 48 3885 3887 +3009 48 3888 3889 +3010 48 3888 3890 +3011 48 3891 3892 +3012 48 3891 3893 +3013 48 3894 3895 +3014 48 3894 3896 +3015 48 3897 3898 +3016 48 3897 3899 +3017 48 3900 3901 +3018 48 3900 3902 +3019 48 3903 3904 +3020 48 3903 3905 +3021 48 3906 3907 +3022 48 3906 3908 +3023 48 3909 3910 +3024 48 3909 3911 +3025 48 3912 3913 +3026 48 3912 3914 +3027 48 3915 3916 +3028 48 3915 3917 +3029 48 3918 3919 +3030 48 3918 3920 +3031 48 3921 3922 +3032 48 3921 3923 +3033 48 3924 3925 +3034 48 3924 3926 +3035 48 3927 3928 +3036 48 3927 3929 +3037 48 3930 3931 +3038 48 3930 3932 +3039 48 3933 3934 +3040 48 3933 3935 +3041 48 3936 3937 +3042 48 3936 3938 +3043 48 3939 3940 +3044 48 3939 3941 +3045 48 3942 3943 +3046 48 3942 3944 +3047 48 3945 3946 +3048 48 3945 3947 +3049 48 3948 3949 +3050 48 3948 3950 +3051 48 3951 3952 +3052 48 3951 3953 +3053 48 3954 3955 +3054 48 3954 3956 +3055 48 3957 3958 +3056 48 3957 3959 +3057 48 3960 3961 +3058 48 3960 3962 +3059 48 3963 3964 +3060 48 3963 3965 +3061 48 3966 3967 +3062 48 3966 3968 +3063 48 3969 3970 +3064 48 3969 3971 +3065 48 3972 3973 +3066 48 3972 3974 +3067 48 3975 3976 +3068 48 3975 3977 +3069 48 3978 3979 +3070 48 3978 3980 +3071 48 3981 3982 +3072 48 3981 3983 +3073 48 3984 3985 +3074 48 3984 3986 +3075 48 3987 3988 +3076 48 3987 3989 +3077 48 3990 3991 +3078 48 3990 3992 +3079 48 3993 3994 +3080 48 3993 3995 +3081 48 3996 3997 +3082 48 3996 3998 +3083 48 3999 4000 +3084 48 3999 4001 +3085 48 4002 4003 +3086 48 4002 4004 +3087 48 4005 4006 +3088 48 4005 4007 +3089 48 4008 4009 +3090 48 4008 4010 +3091 48 4011 4012 +3092 48 4011 4013 +3093 48 4014 4015 +3094 48 4014 4016 +3095 48 4017 4018 +3096 48 4017 4019 +3097 48 4020 4021 +3098 48 4020 4022 +3099 48 4023 4024 +3100 48 4023 4025 +3101 48 4026 4027 +3102 48 4026 4028 +3103 48 4029 4030 +3104 48 4029 4031 +3105 48 4032 4033 +3106 48 4032 4034 +3107 48 4035 4036 +3108 48 4035 4037 +3109 48 4038 4039 +3110 48 4038 4040 +3111 48 4041 4042 +3112 48 4041 4043 +3113 48 4044 4045 +3114 48 4044 4046 +3115 48 4047 4048 +3116 48 4047 4049 +3117 48 4050 4051 +3118 48 4050 4052 +3119 48 4053 4054 +3120 48 4053 4055 +3121 48 4056 4057 +3122 48 4056 4058 +3123 48 4059 4060 +3124 48 4059 4061 +3125 48 4062 4063 +3126 48 4062 4064 +3127 48 4065 4066 +3128 48 4065 4067 +3129 48 4068 4069 +3130 48 4068 4070 +3131 48 4071 4072 +3132 48 4071 4073 +3133 48 4074 4075 +3134 48 4074 4076 +3135 48 4077 4078 +3136 48 4077 4079 +3137 48 4080 4081 +3138 48 4080 4082 +3139 48 4083 4084 +3140 48 4083 4085 +3141 48 4086 4087 +3142 48 4086 4088 +3143 48 4089 4090 +3144 48 4089 4091 +3145 48 4092 4093 +3146 48 4092 4094 +3147 48 4095 4096 +3148 48 4095 4097 +3149 48 4098 4099 +3150 48 4098 4100 +3151 48 4101 4102 +3152 48 4101 4103 +3153 48 4104 4105 +3154 48 4104 4106 +3155 48 4107 4108 +3156 48 4107 4109 +3157 48 4110 4111 +3158 48 4110 4112 +3159 48 4113 4114 +3160 48 4113 4115 +3161 48 4116 4117 +3162 48 4116 4118 +3163 48 4119 4120 +3164 48 4119 4121 +3165 48 4122 4123 +3166 48 4122 4124 +3167 48 4125 4126 +3168 48 4125 4127 +3169 48 4128 4129 +3170 48 4128 4130 +3171 48 4131 4132 +3172 48 4131 4133 +3173 48 4134 4135 +3174 48 4134 4136 +3175 48 4137 4138 +3176 48 4137 4139 +3177 48 4140 4141 +3178 48 4140 4142 +3179 48 4143 4144 +3180 48 4143 4145 +3181 48 4146 4147 +3182 48 4146 4148 +3183 48 4149 4150 +3184 48 4149 4151 +3185 48 4152 4153 +3186 48 4152 4154 +3187 48 4155 4156 +3188 48 4155 4157 +3189 48 4158 4159 +3190 48 4158 4160 +3191 48 4161 4162 +3192 48 4161 4163 +3193 48 4164 4165 +3194 48 4164 4166 +3195 48 4167 4168 +3196 48 4167 4169 +3197 48 4170 4171 +3198 48 4170 4172 +3199 48 4173 4174 +3200 48 4173 4175 +3201 48 4176 4177 +3202 48 4176 4178 +3203 48 4179 4180 +3204 48 4179 4181 +3205 48 4182 4183 +3206 48 4182 4184 +3207 48 4185 4186 +3208 48 4185 4187 +3209 48 4188 4189 +3210 48 4188 4190 +3211 48 4191 4192 +3212 48 4191 4193 +3213 48 4194 4195 +3214 48 4194 4196 +3215 48 4197 4198 +3216 48 4197 4199 +3217 48 4200 4201 +3218 48 4200 4202 +3219 48 4203 4204 +3220 48 4203 4205 +3221 48 4206 4207 +3222 48 4206 4208 +3223 48 4209 4210 +3224 48 4209 4211 +3225 48 4212 4213 +3226 48 4212 4214 +3227 48 4215 4216 +3228 48 4215 4217 +3229 48 4218 4219 +3230 48 4218 4220 +3231 48 4221 4222 +3232 48 4221 4223 +3233 48 4224 4225 +3234 48 4224 4226 +3235 48 4227 4228 +3236 48 4227 4229 +3237 48 4230 4231 +3238 48 4230 4232 +3239 48 4233 4234 +3240 48 4233 4235 +3241 48 4236 4237 +3242 48 4236 4238 +3243 48 4239 4240 +3244 48 4239 4241 +3245 48 4242 4243 +3246 48 4242 4244 +3247 48 4245 4246 +3248 48 4245 4247 +3249 48 4248 4249 +3250 48 4248 4250 +3251 48 4251 4252 +3252 48 4251 4253 +3253 48 4254 4255 +3254 48 4254 4256 +3255 48 4257 4258 +3256 48 4257 4259 +3257 48 4260 4261 +3258 48 4260 4262 +3259 48 4263 4264 +3260 48 4263 4265 +3261 48 4266 4267 +3262 48 4266 4268 +3263 48 4269 4270 +3264 48 4269 4271 +3265 48 4272 4273 +3266 48 4272 4274 +3267 48 4275 4276 +3268 48 4275 4277 +3269 48 4278 4279 +3270 48 4278 4280 +3271 48 4281 4282 +3272 48 4281 4283 +3273 48 4284 4285 +3274 48 4284 4286 +3275 48 4287 4288 +3276 48 4287 4289 +3277 48 4290 4291 +3278 48 4290 4292 +3279 48 4293 4294 +3280 48 4293 4295 +3281 48 4296 4297 +3282 48 4296 4298 +3283 48 4299 4300 +3284 48 4299 4301 +3285 48 4302 4303 +3286 48 4302 4304 +3287 48 4305 4306 +3288 48 4305 4307 +3289 48 4308 4309 +3290 48 4308 4310 +3291 48 4311 4312 +3292 48 4311 4313 +3293 48 4314 4315 +3294 48 4314 4316 +3295 48 4317 4318 +3296 48 4317 4319 +3297 48 4320 4321 +3298 48 4320 4322 +3299 48 4323 4324 +3300 48 4323 4325 +3301 48 4326 4327 +3302 48 4326 4328 +3303 48 4329 4330 +3304 48 4329 4331 +3305 48 4332 4333 +3306 48 4332 4334 +3307 48 4335 4336 +3308 48 4335 4337 +3309 48 4338 4339 +3310 48 4338 4340 +3311 48 4341 4342 +3312 48 4341 4343 +3313 48 4344 4345 +3314 48 4344 4346 +3315 48 4347 4348 +3316 48 4347 4349 +3317 48 4350 4351 +3318 48 4350 4352 +3319 48 4353 4354 +3320 48 4353 4355 +3321 48 4356 4357 +3322 48 4356 4358 +3323 48 4359 4360 +3324 48 4359 4361 +3325 48 4362 4363 +3326 48 4362 4364 +3327 48 4365 4366 +3328 48 4365 4367 +3329 48 4368 4369 +3330 48 4368 4370 +3331 48 4371 4372 +3332 48 4371 4373 +3333 48 4374 4375 +3334 48 4374 4376 +3335 48 4377 4378 +3336 48 4377 4379 +3337 48 4380 4381 +3338 48 4380 4382 +3339 48 4383 4384 +3340 48 4383 4385 +3341 48 4386 4387 +3342 48 4386 4388 +3343 48 4389 4390 +3344 48 4389 4391 +3345 48 4392 4393 +3346 48 4392 4394 +3347 48 4395 4396 +3348 48 4395 4397 +3349 48 4398 4399 +3350 48 4398 4400 +3351 48 4401 4402 +3352 48 4401 4403 +3353 48 4404 4405 +3354 48 4404 4406 +3355 48 4407 4408 +3356 48 4407 4409 +3357 48 4410 4411 +3358 48 4410 4412 +3359 48 4413 4414 +3360 48 4413 4415 +3361 48 4416 4417 +3362 48 4416 4418 +3363 48 4419 4420 +3364 48 4419 4421 +3365 48 4422 4423 +3366 48 4422 4424 +3367 48 4425 4426 +3368 48 4425 4427 +3369 48 4428 4429 +3370 48 4428 4430 +3371 48 4431 4432 +3372 48 4431 4433 +3373 48 4434 4435 +3374 48 4434 4436 +3375 48 4437 4438 +3376 48 4437 4439 +3377 48 4440 4441 +3378 48 4440 4442 +3379 48 4443 4444 +3380 48 4443 4445 +3381 48 4446 4447 +3382 48 4446 4448 +3383 48 4449 4450 +3384 48 4449 4451 +3385 48 4452 4453 +3386 48 4452 4454 +3387 48 4455 4456 +3388 48 4455 4457 +3389 48 4458 4459 +3390 48 4458 4460 +3391 48 4461 4462 +3392 48 4461 4463 +3393 48 4464 4465 +3394 48 4464 4466 +3395 48 4467 4468 +3396 48 4467 4469 +3397 48 4470 4471 +3398 48 4470 4472 +3399 48 4473 4474 +3400 48 4473 4475 +3401 48 4476 4477 +3402 48 4476 4478 +3403 48 4479 4480 +3404 48 4479 4481 +3405 48 4482 4483 +3406 48 4482 4484 +3407 48 4485 4486 +3408 48 4485 4487 +3409 48 4488 4489 +3410 48 4488 4490 +3411 48 4491 4492 +3412 48 4491 4493 +3413 48 4494 4495 +3414 48 4494 4496 +3415 48 4497 4498 +3416 48 4497 4499 +3417 48 4500 4501 +3418 48 4500 4502 +3419 48 4503 4504 +3420 48 4503 4505 +3421 48 4506 4507 +3422 48 4506 4508 +3423 48 4509 4510 +3424 48 4509 4511 +3425 48 4512 4513 +3426 48 4512 4514 +3427 48 4515 4516 +3428 48 4515 4517 +3429 48 4518 4519 +3430 48 4518 4520 +3431 48 4521 4522 +3432 48 4521 4523 +3433 48 4524 4525 +3434 48 4524 4526 +3435 48 4527 4528 +3436 48 4527 4529 +3437 48 4530 4531 +3438 48 4530 4532 +3439 48 4533 4534 +3440 48 4533 4535 +3441 48 4536 4537 +3442 48 4536 4538 +3443 48 4539 4540 +3444 48 4539 4541 +3445 48 4542 4543 +3446 48 4542 4544 +3447 48 4545 4546 +3448 48 4545 4547 +3449 48 4548 4549 +3450 48 4548 4550 +3451 48 4551 4552 +3452 48 4551 4553 +3453 48 4554 4555 +3454 48 4554 4556 +3455 48 4557 4558 +3456 48 4557 4559 +3457 48 4560 4561 +3458 48 4560 4562 +3459 48 4563 4564 +3460 48 4563 4565 +3461 48 4566 4567 +3462 48 4566 4568 +3463 48 4569 4570 +3464 48 4569 4571 +3465 48 4572 4573 +3466 48 4572 4574 +3467 48 4575 4576 +3468 48 4575 4577 +3469 48 4578 4579 +3470 48 4578 4580 +3471 48 4581 4582 +3472 48 4581 4583 +3473 48 4584 4585 +3474 48 4584 4586 +3475 48 4587 4588 +3476 48 4587 4589 +3477 48 4590 4591 +3478 48 4590 4592 +3479 48 4593 4594 +3480 48 4593 4595 +3481 48 4596 4597 +3482 48 4596 4598 +3483 48 4599 4600 +3484 48 4599 4601 +3485 48 4602 4603 +3486 48 4602 4604 +3487 48 4605 4606 +3488 48 4605 4607 +3489 48 4608 4609 +3490 48 4608 4610 +3491 48 4611 4612 +3492 48 4611 4613 +3493 48 4614 4615 +3494 48 4614 4616 +3495 48 4617 4618 +3496 48 4617 4619 +3497 48 4620 4621 +3498 48 4620 4622 +3499 48 4623 4624 +3500 48 4623 4625 +3501 48 4626 4627 +3502 48 4626 4628 +3503 48 4629 4630 +3504 48 4629 4631 +3505 48 4632 4633 +3506 48 4632 4634 +3507 48 4635 4636 +3508 48 4635 4637 +3509 48 4638 4639 +3510 48 4638 4640 +3511 48 4641 4642 +3512 48 4641 4643 +3513 48 4644 4645 +3514 48 4644 4646 +3515 48 4647 4648 +3516 48 4647 4649 +3517 48 4650 4651 +3518 48 4650 4652 +3519 48 4653 4654 +3520 48 4653 4655 +3521 48 4656 4657 +3522 48 4656 4658 +3523 48 4659 4660 +3524 48 4659 4661 +3525 48 4662 4663 +3526 48 4662 4664 +3527 48 4665 4666 +3528 48 4665 4667 +3529 48 4668 4669 +3530 48 4668 4670 +3531 48 4671 4672 +3532 48 4671 4673 +3533 48 4674 4675 +3534 48 4674 4676 +3535 48 4677 4678 +3536 48 4677 4679 +3537 48 4680 4681 +3538 48 4680 4682 +3539 48 4683 4684 +3540 48 4683 4685 +3541 48 4686 4687 +3542 48 4686 4688 +3543 48 4689 4690 +3544 48 4689 4691 +3545 48 4692 4693 +3546 48 4692 4694 +3547 48 4695 4696 +3548 48 4695 4697 +3549 48 4698 4699 +3550 48 4698 4700 +3551 48 4701 4702 +3552 48 4701 4703 +3553 48 4704 4705 +3554 48 4704 4706 +3555 48 4707 4708 +3556 48 4707 4709 +3557 48 4710 4711 +3558 48 4710 4712 +3559 48 4713 4714 +3560 48 4713 4715 +3561 48 4716 4717 +3562 48 4716 4718 +3563 48 4719 4720 +3564 48 4719 4721 +3565 48 4722 4723 +3566 48 4722 4724 +3567 48 4725 4726 +3568 48 4725 4727 +3569 48 4728 4729 +3570 48 4728 4730 +3571 48 4731 4732 +3572 48 4731 4733 +3573 48 4734 4735 +3574 48 4734 4736 +3575 48 4737 4738 +3576 48 4737 4739 +3577 48 4740 4741 +3578 48 4740 4742 +3579 48 4743 4744 +3580 48 4743 4745 +3581 48 4746 4747 +3582 48 4746 4748 +3583 48 4749 4750 +3584 48 4749 4751 +3585 48 4752 4753 +3586 48 4752 4754 +3587 48 4755 4756 +3588 48 4755 4757 +3589 48 4758 4759 +3590 48 4758 4760 +3591 48 4761 4762 +3592 48 4761 4763 +3593 48 4764 4765 +3594 48 4764 4766 +3595 48 4767 4768 +3596 48 4767 4769 +3597 48 4770 4771 +3598 48 4770 4772 +3599 48 4773 4774 +3600 48 4773 4775 +3601 48 4776 4777 +3602 48 4776 4778 +3603 48 4779 4780 +3604 48 4779 4781 +3605 48 4782 4783 +3606 48 4782 4784 +3607 48 4785 4786 +3608 48 4785 4787 +3609 48 4788 4789 +3610 48 4788 4790 +3611 48 4791 4792 +3612 48 4791 4793 +3613 48 4794 4795 +3614 48 4794 4796 +3615 48 4797 4798 +3616 48 4797 4799 +3617 48 4800 4801 +3618 48 4800 4802 +3619 48 4803 4804 +3620 48 4803 4805 +3621 48 4806 4807 +3622 48 4806 4808 +3623 48 4809 4810 +3624 48 4809 4811 +3625 48 4812 4813 +3626 48 4812 4814 +3627 48 4815 4816 +3628 48 4815 4817 +3629 48 4818 4819 +3630 48 4818 4820 +3631 48 4821 4822 +3632 48 4821 4823 +3633 48 4824 4825 +3634 48 4824 4826 +3635 48 4827 4828 +3636 48 4827 4829 +3637 48 4830 4831 +3638 48 4830 4832 +3639 48 4833 4834 +3640 48 4833 4835 +3641 48 4836 4837 +3642 48 4836 4838 +3643 48 4839 4840 +3644 48 4839 4841 +3645 48 4842 4843 +3646 48 4842 4844 +3647 48 4845 4846 +3648 48 4845 4847 +3649 48 4848 4849 +3650 48 4848 4850 +3651 48 4851 4852 +3652 48 4851 4853 +3653 48 4854 4855 +3654 48 4854 4856 +3655 48 4857 4858 +3656 48 4857 4859 +3657 48 4860 4861 +3658 48 4860 4862 +3659 48 4863 4864 +3660 48 4863 4865 +3661 48 4866 4867 +3662 48 4866 4868 +3663 48 4869 4870 +3664 48 4869 4871 +3665 48 4872 4873 +3666 48 4872 4874 +3667 48 4875 4876 +3668 48 4875 4877 +3669 48 4878 4879 +3670 48 4878 4880 +3671 48 4881 4882 +3672 48 4881 4883 +3673 48 4884 4885 +3674 48 4884 4886 +3675 48 4887 4888 +3676 48 4887 4889 +3677 48 4890 4891 +3678 48 4890 4892 +3679 48 4893 4894 +3680 48 4893 4895 +3681 48 4896 4897 +3682 48 4896 4898 +3683 48 4899 4900 +3684 48 4899 4901 +3685 48 4902 4903 +3686 48 4902 4904 +3687 48 4905 4906 +3688 48 4905 4907 +3689 48 4908 4909 +3690 48 4908 4910 +3691 48 4911 4912 +3692 48 4911 4913 +3693 48 4914 4915 +3694 48 4914 4916 +3695 48 4917 4918 +3696 48 4917 4919 +3697 48 4920 4921 +3698 48 4920 4922 +3699 48 4923 4924 +3700 48 4923 4925 +3701 48 4926 4927 +3702 48 4926 4928 +3703 48 4929 4930 +3704 48 4929 4931 +3705 48 4932 4933 +3706 48 4932 4934 +3707 48 4935 4936 +3708 48 4935 4937 +3709 48 4938 4939 +3710 48 4938 4940 +3711 48 4941 4942 +3712 48 4941 4943 +3713 48 4944 4945 +3714 48 4944 4946 +3715 48 4947 4948 +3716 48 4947 4949 +3717 48 4950 4951 +3718 48 4950 4952 +3719 48 4953 4954 +3720 48 4953 4955 +3721 48 4956 4957 +3722 48 4956 4958 +3723 48 4959 4960 +3724 48 4959 4961 +3725 48 4962 4963 +3726 48 4962 4964 +3727 48 4965 4966 +3728 48 4965 4967 +3729 48 4968 4969 +3730 48 4968 4970 +3731 48 4971 4972 +3732 48 4971 4973 +3733 48 4974 4975 +3734 48 4974 4976 +3735 48 4977 4978 +3736 48 4977 4979 +3737 48 4980 4981 +3738 48 4980 4982 +3739 48 4983 4984 +3740 48 4983 4985 +3741 48 4986 4987 +3742 48 4986 4988 +3743 48 4989 4990 +3744 48 4989 4991 +3745 48 4992 4993 +3746 48 4992 4994 +3747 48 4995 4996 +3748 48 4995 4997 +3749 48 4998 4999 +3750 48 4998 5000 +3751 48 5001 5002 +3752 48 5001 5003 +3753 48 5004 5005 +3754 48 5004 5006 +3755 48 5007 5008 +3756 48 5007 5009 +3757 48 5010 5011 +3758 48 5010 5012 +3759 48 5013 5014 +3760 48 5013 5015 +3761 48 5016 5017 +3762 48 5016 5018 +3763 48 5019 5020 +3764 48 5019 5021 +3765 48 5022 5023 +3766 48 5022 5024 +3767 48 5025 5026 +3768 48 5025 5027 +3769 48 5028 5029 +3770 48 5028 5030 +3771 48 5031 5032 +3772 48 5031 5033 +3773 48 5034 5035 +3774 48 5034 5036 +3775 48 5037 5038 +3776 48 5037 5039 +3777 48 5040 5041 +3778 48 5040 5042 +3779 48 5043 5044 +3780 48 5043 5045 +3781 48 5046 5047 +3782 48 5046 5048 +3783 48 5049 5050 +3784 48 5049 5051 +3785 48 5052 5053 +3786 48 5052 5054 +3787 48 5055 5056 +3788 48 5055 5057 +3789 48 5058 5059 +3790 48 5058 5060 +3791 48 5061 5062 +3792 48 5061 5063 +3793 48 5064 5065 +3794 48 5064 5066 +3795 48 5067 5068 +3796 48 5067 5069 +3797 48 5070 5071 +3798 48 5070 5072 +3799 48 5073 5074 +3800 48 5073 5075 +3801 48 5076 5077 +3802 48 5076 5078 +3803 48 5079 5080 +3804 48 5079 5081 +3805 48 5082 5083 +3806 48 5082 5084 +3807 48 5085 5086 +3808 48 5085 5087 +3809 48 5088 5089 +3810 48 5088 5090 +3811 48 5091 5092 +3812 48 5091 5093 +3813 48 5094 5095 +3814 48 5094 5096 +3815 48 5097 5098 +3816 48 5097 5099 +3817 48 5100 5101 +3818 48 5100 5102 +3819 48 5103 5104 +3820 48 5103 5105 +3821 48 5106 5107 +3822 48 5106 5108 +3823 48 5109 5110 +3824 48 5109 5111 +3825 48 5112 5113 +3826 48 5112 5114 +3827 48 5115 5116 +3828 48 5115 5117 +3829 48 5118 5119 +3830 48 5118 5120 +3831 48 5121 5122 +3832 48 5121 5123 +3833 48 5124 5125 +3834 48 5124 5126 +3835 48 5127 5128 +3836 48 5127 5129 +3837 48 5130 5131 +3838 48 5130 5132 +3839 48 5133 5134 +3840 48 5133 5135 +3841 48 5136 5137 +3842 48 5136 5138 +3843 48 5139 5140 +3844 48 5139 5141 +3845 48 5142 5143 +3846 48 5142 5144 +3847 48 5145 5146 +3848 48 5145 5147 +3849 48 5148 5149 +3850 48 5148 5150 +3851 48 5151 5152 +3852 48 5151 5153 +3853 48 5154 5155 +3854 48 5154 5156 +3855 48 5157 5158 +3856 48 5157 5159 +3857 48 5160 5161 +3858 48 5160 5162 +3859 48 5163 5164 +3860 48 5163 5165 +3861 48 5166 5167 +3862 48 5166 5168 +3863 48 5169 5170 +3864 48 5169 5171 +3865 48 5172 5173 +3866 48 5172 5174 +3867 48 5175 5176 +3868 48 5175 5177 +3869 48 5178 5179 +3870 48 5178 5180 +3871 48 5181 5182 +3872 48 5181 5183 +3873 48 5184 5185 +3874 48 5184 5186 +3875 48 5187 5188 +3876 48 5187 5189 +3877 48 5190 5191 +3878 48 5190 5192 +3879 48 5193 5194 +3880 48 5193 5195 +3881 48 5196 5197 +3882 48 5196 5198 +3883 48 5199 5200 +3884 48 5199 5201 +3885 48 5202 5203 +3886 48 5202 5204 +3887 48 5205 5206 +3888 48 5205 5207 +3889 48 5208 5209 +3890 48 5208 5210 +3891 48 5211 5212 +3892 48 5211 5213 +3893 48 5214 5215 +3894 48 5214 5216 +3895 48 5217 5218 +3896 48 5217 5219 +3897 48 5220 5221 +3898 48 5220 5222 +3899 48 5223 5224 +3900 48 5223 5225 +3901 48 5226 5227 +3902 48 5226 5228 +3903 48 5229 5230 +3904 48 5229 5231 +3905 48 5232 5233 +3906 48 5232 5234 +3907 48 5235 5236 +3908 48 5235 5237 +3909 48 5238 5239 +3910 48 5238 5240 +3911 48 5241 5242 +3912 48 5241 5243 +3913 48 5244 5245 +3914 48 5244 5246 +3915 48 5247 5248 +3916 48 5247 5249 +3917 48 5250 5251 +3918 48 5250 5252 +3919 48 5253 5254 +3920 48 5253 5255 +3921 48 5256 5257 +3922 48 5256 5258 +3923 48 5259 5260 +3924 48 5259 5261 +3925 48 5262 5263 +3926 48 5262 5264 +3927 48 5265 5266 +3928 48 5265 5267 +3929 48 5268 5269 +3930 48 5268 5270 +3931 48 5271 5272 +3932 48 5271 5273 +3933 48 5274 5275 +3934 48 5274 5276 +3935 48 5277 5278 +3936 48 5277 5279 +3937 48 5280 5281 +3938 48 5280 5282 +3939 48 5283 5284 +3940 48 5283 5285 +3941 48 5286 5287 +3942 48 5286 5288 +3943 48 5289 5290 +3944 48 5289 5291 +3945 48 5292 5293 +3946 48 5292 5294 +3947 48 5295 5296 +3948 48 5295 5297 +3949 48 5298 5299 +3950 48 5298 5300 +3951 48 5301 5302 +3952 48 5301 5303 +3953 48 5304 5305 +3954 48 5304 5306 +3955 48 5307 5308 +3956 48 5307 5309 +3957 48 5310 5311 +3958 48 5310 5312 +3959 48 5313 5314 +3960 48 5313 5315 +3961 48 5316 5317 +3962 48 5316 5318 +3963 48 5319 5320 +3964 48 5319 5321 +3965 48 5322 5323 +3966 48 5322 5324 +3967 48 5325 5326 +3968 48 5325 5327 +3969 48 5328 5329 +3970 48 5328 5330 +3971 48 5331 5332 +3972 48 5331 5333 +3973 48 5334 5335 +3974 48 5334 5336 +3975 48 5337 5338 +3976 48 5337 5339 +3977 48 5340 5341 +3978 48 5340 5342 +3979 48 5343 5344 +3980 48 5343 5345 +3981 48 5346 5347 +3982 48 5346 5348 +3983 48 5349 5350 +3984 48 5349 5351 +3985 48 5352 5353 +3986 48 5352 5354 +3987 48 5355 5356 +3988 48 5355 5357 +3989 48 5358 5359 +3990 48 5358 5360 +3991 48 5361 5362 +3992 48 5361 5363 +3993 48 5364 5365 +3994 48 5364 5366 +3995 48 5367 5368 +3996 48 5367 5369 +3997 48 5370 5371 +3998 48 5370 5372 +3999 48 5373 5374 +4000 48 5373 5375 +4001 48 5376 5377 +4002 48 5376 5378 +4003 48 5379 5380 +4004 48 5379 5381 +4005 48 5382 5383 +4006 48 5382 5384 +4007 48 5385 5386 +4008 48 5385 5387 +4009 48 5388 5389 +4010 48 5388 5390 +4011 48 5391 5392 +4012 48 5391 5393 +4013 48 5394 5395 +4014 48 5394 5396 +4015 48 5397 5398 +4016 48 5397 5399 +4017 48 5400 5401 +4018 48 5400 5402 +4019 48 5403 5404 +4020 48 5403 5405 +4021 48 5406 5407 +4022 48 5406 5408 +4023 48 5409 5410 +4024 48 5409 5411 +4025 48 5412 5413 +4026 48 5412 5414 +4027 48 5415 5416 +4028 48 5415 5417 +4029 48 5418 5419 +4030 48 5418 5420 +4031 48 5421 5422 +4032 48 5421 5423 +4033 48 5424 5425 +4034 48 5424 5426 +4035 48 5427 5428 +4036 48 5427 5429 +4037 48 5430 5431 +4038 48 5430 5432 +4039 48 5433 5434 +4040 48 5433 5435 +4041 48 5436 5437 +4042 48 5436 5438 +4043 48 5439 5440 +4044 48 5439 5441 +4045 48 5442 5443 +4046 48 5442 5444 +4047 48 5445 5446 +4048 48 5445 5447 +4049 48 5448 5449 +4050 48 5448 5450 +4051 48 5451 5452 +4052 48 5451 5453 +4053 48 5454 5455 +4054 48 5454 5456 +4055 48 5457 5458 +4056 48 5457 5459 +4057 48 5460 5461 +4058 48 5460 5462 +4059 48 5463 5464 +4060 48 5463 5465 +4061 48 5466 5467 +4062 48 5466 5468 +4063 48 5469 5470 +4064 48 5469 5471 +4065 48 5472 5473 +4066 48 5472 5474 +4067 48 5475 5476 +4068 48 5475 5477 +4069 48 5478 5479 +4070 48 5478 5480 +4071 48 5481 5482 +4072 48 5481 5483 +4073 48 5484 5485 +4074 48 5484 5486 +4075 48 5487 5488 +4076 48 5487 5489 +4077 48 5490 5491 +4078 48 5490 5492 +4079 48 5493 5494 +4080 48 5493 5495 +4081 48 5496 5497 +4082 48 5496 5498 +4083 48 5499 5500 +4084 48 5499 5501 +4085 48 5502 5503 +4086 48 5502 5504 +4087 48 5505 5506 +4088 48 5505 5507 +4089 48 5508 5509 +4090 48 5508 5510 +4091 48 5511 5512 +4092 48 5511 5513 +4093 48 5514 5515 +4094 48 5514 5516 +4095 48 5517 5518 +4096 48 5517 5519 +4097 48 5520 5521 +4098 48 5520 5522 +4099 48 5523 5524 +4100 48 5523 5525 +4101 48 5526 5527 +4102 48 5526 5528 +4103 48 5529 5530 +4104 48 5529 5531 +4105 48 5532 5533 +4106 48 5532 5534 +4107 48 5535 5536 +4108 48 5535 5537 +4109 48 5538 5539 +4110 48 5538 5540 +4111 48 5541 5542 +4112 48 5541 5543 +4113 48 5544 5545 +4114 48 5544 5546 +4115 48 5547 5548 +4116 48 5547 5549 +4117 48 5550 5551 +4118 48 5550 5552 +4119 48 5553 5554 +4120 48 5553 5555 +4121 48 5556 5557 +4122 48 5556 5558 +4123 48 5559 5560 +4124 48 5559 5561 +4125 48 5562 5563 +4126 48 5562 5564 +4127 48 5565 5566 +4128 48 5565 5567 +4129 48 5568 5569 +4130 48 5568 5570 +4131 48 5571 5572 +4132 48 5571 5573 +4133 48 5574 5575 +4134 48 5574 5576 +4135 48 5577 5578 +4136 48 5577 5579 +4137 48 5580 5581 +4138 48 5580 5582 +4139 48 5583 5584 +4140 48 5583 5585 +4141 48 5586 5587 +4142 48 5586 5588 +4143 48 5589 5590 +4144 48 5589 5591 +4145 48 5592 5593 +4146 48 5592 5594 +4147 48 5595 5596 +4148 48 5595 5597 +4149 48 5598 5599 +4150 48 5598 5600 +4151 48 5601 5602 +4152 48 5601 5603 +4153 48 5604 5605 +4154 48 5604 5606 +4155 48 5607 5608 +4156 48 5607 5609 +4157 48 5610 5611 +4158 48 5610 5612 +4159 48 5613 5614 +4160 48 5613 5615 +4161 48 5616 5617 +4162 48 5616 5618 +4163 48 5619 5620 +4164 48 5619 5621 +4165 48 5622 5623 +4166 48 5622 5624 +4167 48 5625 5626 +4168 48 5625 5627 +4169 48 5628 5629 +4170 48 5628 5630 +4171 48 5631 5632 +4172 48 5631 5633 +4173 48 5634 5635 +4174 48 5634 5636 +4175 48 5637 5638 +4176 48 5637 5639 +4177 48 5640 5641 +4178 48 5640 5642 +4179 48 5643 5644 +4180 48 5643 5645 +4181 48 5646 5647 +4182 48 5646 5648 +4183 48 5649 5650 +4184 48 5649 5651 +4185 48 5652 5653 +4186 48 5652 5654 +4187 48 5655 5656 +4188 48 5655 5657 +4189 48 5658 5659 +4190 48 5658 5660 +4191 48 5661 5662 +4192 48 5661 5663 +4193 48 5664 5665 +4194 48 5664 5666 +4195 48 5667 5668 +4196 48 5667 5669 +4197 48 5670 5671 +4198 48 5670 5672 +4199 48 5673 5674 +4200 48 5673 5675 +4201 48 5676 5677 +4202 48 5676 5678 +4203 48 5679 5680 +4204 48 5679 5681 +4205 48 5682 5683 +4206 48 5682 5684 +4207 48 5685 5686 +4208 48 5685 5687 +4209 48 5688 5689 +4210 48 5688 5690 +4211 48 5691 5692 +4212 48 5691 5693 +4213 48 5694 5695 +4214 48 5694 5696 +4215 48 5697 5698 +4216 48 5697 5699 +4217 48 5700 5701 +4218 48 5700 5702 +4219 48 5703 5704 +4220 48 5703 5705 +4221 48 5706 5707 +4222 48 5706 5708 +4223 48 5709 5710 +4224 48 5709 5711 +4225 48 5712 5713 +4226 48 5712 5714 +4227 48 5715 5716 +4228 48 5715 5717 +4229 48 5718 5719 +4230 48 5718 5720 +4231 48 5721 5722 +4232 48 5721 5723 +4233 48 5724 5725 +4234 48 5724 5726 +4235 48 5727 5728 +4236 48 5727 5729 +4237 48 5730 5731 +4238 48 5730 5732 +4239 48 5733 5734 +4240 48 5733 5735 +4241 48 5736 5737 +4242 48 5736 5738 +4243 48 5739 5740 +4244 48 5739 5741 +4245 48 5742 5743 +4246 48 5742 5744 +4247 48 5745 5746 +4248 48 5745 5747 +4249 48 5748 5749 +4250 48 5748 5750 +4251 48 5751 5752 +4252 48 5751 5753 +4253 48 5754 5755 +4254 48 5754 5756 +4255 48 5757 5758 +4256 48 5757 5759 +4257 48 5760 5761 +4258 48 5760 5762 +4259 48 5763 5764 +4260 48 5763 5765 +4261 48 5766 5767 +4262 48 5766 5768 +4263 48 5769 5770 +4264 48 5769 5771 +4265 48 5772 5773 +4266 48 5772 5774 +4267 48 5775 5776 +4268 48 5775 5777 +4269 48 5778 5779 +4270 48 5778 5780 +4271 48 5781 5782 +4272 48 5781 5783 +4273 48 5784 5785 +4274 48 5784 5786 +4275 48 5787 5788 +4276 48 5787 5789 +4277 48 5790 5791 +4278 48 5790 5792 +4279 48 5793 5794 +4280 48 5793 5795 +4281 48 5796 5797 +4282 48 5796 5798 +4283 48 5799 5800 +4284 48 5799 5801 +4285 48 5802 5803 +4286 48 5802 5804 +4287 48 5805 5806 +4288 48 5805 5807 +4289 48 5808 5809 +4290 48 5808 5810 +4291 48 5811 5812 +4292 48 5811 5813 +4293 48 5814 5815 +4294 48 5814 5816 +4295 48 5817 5818 +4296 48 5817 5819 +4297 48 5820 5821 +4298 48 5820 5822 +4299 48 5823 5824 +4300 48 5823 5825 +4301 48 5826 5827 +4302 48 5826 5828 +4303 48 5829 5830 +4304 48 5829 5831 +4305 48 5832 5833 +4306 48 5832 5834 +4307 48 5835 5836 +4308 48 5835 5837 +4309 48 5838 5839 +4310 48 5838 5840 +4311 48 5841 5842 +4312 48 5841 5843 +4313 48 5844 5845 +4314 48 5844 5846 +4315 48 5847 5848 +4316 48 5847 5849 +4317 48 5850 5851 +4318 48 5850 5852 +4319 48 5853 5854 +4320 48 5853 5855 +4321 48 5856 5857 +4322 48 5856 5858 +4323 48 5859 5860 +4324 48 5859 5861 +4325 48 5862 5863 +4326 48 5862 5864 +4327 48 5865 5866 +4328 48 5865 5867 +4329 48 5868 5869 +4330 48 5868 5870 +4331 48 5871 5872 +4332 48 5871 5873 +4333 48 5874 5875 +4334 48 5874 5876 +4335 48 5877 5878 +4336 48 5877 5879 +4337 48 5880 5881 +4338 48 5880 5882 +4339 48 5883 5884 +4340 48 5883 5885 +4341 48 5886 5887 +4342 48 5886 5888 +4343 48 5889 5890 +4344 48 5889 5891 +4345 48 5892 5893 +4346 48 5892 5894 +4347 48 5895 5896 +4348 48 5895 5897 +4349 48 5898 5899 +4350 48 5898 5900 +4351 48 5901 5902 +4352 48 5901 5903 +4353 48 5904 5905 +4354 48 5904 5906 +4355 48 5907 5908 +4356 48 5907 5909 +4357 48 5910 5911 +4358 48 5910 5912 +4359 48 5913 5914 +4360 48 5913 5915 +4361 48 5916 5917 +4362 48 5916 5918 +4363 48 5919 5920 +4364 48 5919 5921 +4365 48 5922 5923 +4366 48 5922 5924 +4367 48 5925 5926 +4368 48 5925 5927 +4369 48 5928 5929 +4370 48 5928 5930 +4371 48 5931 5932 +4372 48 5931 5933 +4373 48 5934 5935 +4374 48 5934 5936 +4375 48 5937 5938 +4376 48 5937 5939 +4377 48 5940 5941 +4378 48 5940 5942 +4379 48 5943 5944 +4380 48 5943 5945 +4381 48 5946 5947 +4382 48 5946 5948 +4383 48 5949 5950 +4384 48 5949 5951 +4385 48 5952 5953 +4386 48 5952 5954 +4387 48 5955 5956 +4388 48 5955 5957 +4389 48 5958 5959 +4390 48 5958 5960 +4391 48 5961 5962 +4392 48 5961 5963 +4393 48 5964 5965 +4394 48 5964 5966 +4395 48 5967 5968 +4396 48 5967 5969 +4397 48 5970 5971 +4398 48 5970 5972 +4399 48 5973 5974 +4400 48 5973 5975 +4401 48 5976 5977 +4402 48 5976 5978 +4403 48 5979 5980 +4404 48 5979 5981 +4405 48 5982 5983 +4406 48 5982 5984 +4407 48 5985 5986 +4408 48 5985 5987 +4409 48 5988 5989 +4410 48 5988 5990 +4411 48 5991 5992 +4412 48 5991 5993 +4413 48 5994 5995 +4414 48 5994 5996 +4415 48 5997 5998 +4416 48 5997 5999 +4417 48 6000 6001 +4418 48 6000 6002 +4419 48 6003 6004 +4420 48 6003 6005 +4421 48 6006 6007 +4422 48 6006 6008 +4423 48 6009 6010 +4424 48 6009 6011 +4425 48 6012 6013 +4426 48 6012 6014 +4427 48 6015 6016 +4428 48 6015 6017 +4429 48 6018 6019 +4430 48 6018 6020 +4431 48 6021 6022 +4432 48 6021 6023 +4433 48 6024 6025 +4434 48 6024 6026 +4435 48 6027 6028 +4436 48 6027 6029 +4437 48 6030 6031 +4438 48 6030 6032 +4439 48 6033 6034 +4440 48 6033 6035 +4441 48 6036 6037 +4442 48 6036 6038 +4443 48 6039 6040 +4444 48 6039 6041 +4445 48 6042 6043 +4446 48 6042 6044 +4447 48 6045 6046 +4448 48 6045 6047 +4449 48 6048 6049 +4450 48 6048 6050 +4451 48 6051 6052 +4452 48 6051 6053 +4453 48 6054 6055 +4454 48 6054 6056 +4455 48 6057 6058 +4456 48 6057 6059 +4457 48 6060 6061 +4458 48 6060 6062 +4459 48 6063 6064 +4460 48 6063 6065 +4461 48 6066 6067 +4462 48 6066 6068 +4463 48 6069 6070 +4464 48 6069 6071 +4465 48 6072 6073 +4466 48 6072 6074 +4467 48 6075 6076 +4468 48 6075 6077 +4469 48 6078 6079 +4470 48 6078 6080 +4471 48 6081 6082 +4472 48 6081 6083 +4473 48 6084 6085 +4474 48 6084 6086 +4475 48 6087 6088 +4476 48 6087 6089 +4477 48 6090 6091 +4478 48 6090 6092 +4479 48 6093 6094 +4480 48 6093 6095 +4481 48 6096 6097 +4482 48 6096 6098 +4483 48 6099 6100 +4484 48 6099 6101 +4485 48 6102 6103 +4486 48 6102 6104 +4487 48 6105 6106 +4488 48 6105 6107 +4489 48 6108 6109 +4490 48 6108 6110 +4491 48 6111 6112 +4492 48 6111 6113 +4493 48 6114 6115 +4494 48 6114 6116 +4495 48 6117 6118 +4496 48 6117 6119 +4497 48 6120 6121 +4498 48 6120 6122 +4499 48 6123 6124 +4500 48 6123 6125 +4501 48 6126 6127 +4502 48 6126 6128 +4503 48 6129 6130 +4504 48 6129 6131 +4505 48 6132 6133 +4506 48 6132 6134 +4507 48 6135 6136 +4508 48 6135 6137 +4509 48 6138 6139 +4510 48 6138 6140 +4511 48 6141 6142 +4512 48 6141 6143 +4513 48 6144 6145 +4514 48 6144 6146 +4515 48 6147 6148 +4516 48 6147 6149 +4517 48 6150 6151 +4518 48 6150 6152 +4519 48 6153 6154 +4520 48 6153 6155 +4521 48 6156 6157 +4522 48 6156 6158 +4523 48 6159 6160 +4524 48 6159 6161 +4525 48 6162 6163 +4526 48 6162 6164 +4527 48 6165 6166 +4528 48 6165 6167 +4529 48 6168 6169 +4530 48 6168 6170 +4531 48 6171 6172 +4532 48 6171 6173 +4533 48 6174 6175 +4534 48 6174 6176 +4535 48 6177 6178 +4536 48 6177 6179 +4537 48 6180 6181 +4538 48 6180 6182 +4539 48 6183 6184 +4540 48 6183 6185 +4541 48 6186 6187 +4542 48 6186 6188 +4543 48 6189 6190 +4544 48 6189 6191 +4545 48 6192 6193 +4546 48 6192 6194 +4547 48 6195 6196 +4548 48 6195 6197 +4549 48 6198 6199 +4550 48 6198 6200 +4551 48 6201 6202 +4552 48 6201 6203 +4553 48 6204 6205 +4554 48 6204 6206 +4555 48 6207 6208 +4556 48 6207 6209 +4557 48 6210 6211 +4558 48 6210 6212 +4559 48 6213 6214 +4560 48 6213 6215 +4561 48 6216 6217 +4562 48 6216 6218 +4563 48 6219 6220 +4564 48 6219 6221 +4565 48 6222 6223 +4566 48 6222 6224 +4567 48 6225 6226 +4568 48 6225 6227 +4569 48 6228 6229 +4570 48 6228 6230 +4571 48 6231 6232 +4572 48 6231 6233 +4573 48 6234 6235 +4574 48 6234 6236 +4575 48 6237 6238 +4576 48 6237 6239 +4577 48 6240 6241 +4578 48 6240 6242 +4579 48 6243 6244 +4580 48 6243 6245 +4581 48 6246 6247 +4582 48 6246 6248 +4583 48 6249 6250 +4584 48 6249 6251 +4585 48 6252 6253 +4586 48 6252 6254 +4587 48 6255 6256 +4588 48 6255 6257 +4589 48 6258 6259 +4590 48 6258 6260 +4591 48 6261 6262 +4592 48 6261 6263 +4593 48 6264 6265 +4594 48 6264 6266 +4595 48 6267 6268 +4596 48 6267 6269 +4597 48 6270 6271 +4598 48 6270 6272 +4599 48 6273 6274 +4600 48 6273 6275 +4601 48 6276 6277 +4602 48 6276 6278 +4603 48 6279 6280 +4604 48 6279 6281 +4605 48 6282 6283 +4606 48 6282 6284 +4607 48 6285 6286 +4608 48 6285 6287 +4609 48 6288 6289 +4610 48 6288 6290 +4611 48 6291 6292 +4612 48 6291 6293 +4613 48 6294 6295 +4614 48 6294 6296 +4615 48 6297 6298 +4616 48 6297 6299 +4617 48 6300 6301 +4618 48 6300 6302 +4619 48 6303 6304 +4620 48 6303 6305 +4621 48 6306 6307 +4622 48 6306 6308 +4623 48 6309 6310 +4624 48 6309 6311 +4625 48 6312 6313 +4626 48 6312 6314 +4627 48 6315 6316 +4628 48 6315 6317 +4629 48 6318 6319 +4630 48 6318 6320 +4631 48 6321 6322 +4632 48 6321 6323 +4633 48 6324 6325 +4634 48 6324 6326 +4635 48 6327 6328 +4636 48 6327 6329 +4637 48 6330 6331 +4638 48 6330 6332 +4639 48 6333 6334 +4640 48 6333 6335 +4641 48 6336 6337 +4642 48 6336 6338 +4643 48 6339 6340 +4644 48 6339 6341 +4645 48 6342 6343 +4646 48 6342 6344 +4647 48 6345 6346 +4648 48 6345 6347 +4649 48 6348 6349 +4650 48 6348 6350 +4651 48 6351 6352 +4652 48 6351 6353 +4653 48 6354 6355 +4654 48 6354 6356 +4655 48 6357 6358 +4656 48 6357 6359 +4657 48 6360 6361 +4658 48 6360 6362 +4659 48 6363 6364 +4660 48 6363 6365 +4661 48 6366 6367 +4662 48 6366 6368 +4663 48 6369 6370 +4664 48 6369 6371 +4665 48 6372 6373 +4666 48 6372 6374 +4667 48 6375 6376 +4668 48 6375 6377 +4669 48 6378 6379 +4670 48 6378 6380 +4671 48 6381 6382 +4672 48 6381 6383 +4673 48 6384 6385 +4674 48 6384 6386 +4675 48 6387 6388 +4676 48 6387 6389 +4677 48 6390 6391 +4678 48 6390 6392 +4679 48 6393 6394 +4680 48 6393 6395 +4681 48 6396 6397 +4682 48 6396 6398 +4683 48 6399 6400 +4684 48 6399 6401 +4685 48 6402 6403 +4686 48 6402 6404 +4687 48 6405 6406 +4688 48 6405 6407 +4689 48 6408 6409 +4690 48 6408 6410 +4691 48 6411 6412 +4692 48 6411 6413 +4693 48 6414 6415 +4694 48 6414 6416 +4695 48 6417 6418 +4696 48 6417 6419 +4697 48 6420 6421 +4698 48 6420 6422 +4699 48 6423 6424 +4700 48 6423 6425 +4701 48 6426 6427 +4702 48 6426 6428 +4703 48 6429 6430 +4704 48 6429 6431 +4705 48 6432 6433 +4706 48 6432 6434 +4707 48 6435 6436 +4708 48 6435 6437 +4709 48 6438 6439 +4710 48 6438 6440 +4711 48 6441 6442 +4712 48 6441 6443 +4713 48 6444 6445 +4714 48 6444 6446 +4715 48 6447 6448 +4716 48 6447 6449 +4717 48 6450 6451 +4718 48 6450 6452 +4719 48 6453 6454 +4720 48 6453 6455 +4721 48 6456 6457 +4722 48 6456 6458 +4723 48 6459 6460 +4724 48 6459 6461 +4725 48 6462 6463 +4726 48 6462 6464 +4727 48 6465 6466 +4728 48 6465 6467 +4729 48 6468 6469 +4730 48 6468 6470 +4731 48 6471 6472 +4732 48 6471 6473 +4733 48 6474 6475 +4734 48 6474 6476 +4735 48 6477 6478 +4736 48 6477 6479 +4737 48 6480 6481 +4738 48 6480 6482 +4739 48 6483 6484 +4740 48 6483 6485 +4741 48 6486 6487 +4742 48 6486 6488 +4743 48 6489 6490 +4744 48 6489 6491 +4745 48 6492 6493 +4746 48 6492 6494 +4747 48 6495 6496 +4748 48 6495 6497 +4749 48 6498 6499 +4750 48 6498 6500 +4751 48 6501 6502 +4752 48 6501 6503 +4753 48 6504 6505 +4754 48 6504 6506 +4755 48 6507 6508 +4756 48 6507 6509 +4757 48 6510 6511 +4758 48 6510 6512 +4759 48 6513 6514 +4760 48 6513 6515 +4761 48 6516 6517 +4762 48 6516 6518 +4763 48 6519 6520 +4764 48 6519 6521 +4765 48 6522 6523 +4766 48 6522 6524 +4767 48 6525 6526 +4768 48 6525 6527 +4769 48 6528 6529 +4770 48 6528 6530 +4771 48 6531 6532 +4772 48 6531 6533 +4773 48 6534 6535 +4774 48 6534 6536 +4775 48 6537 6538 +4776 48 6537 6539 +4777 48 6540 6541 +4778 48 6540 6542 +4779 48 6543 6544 +4780 48 6543 6545 +4781 48 6546 6547 +4782 48 6546 6548 +4783 48 6549 6550 +4784 48 6549 6551 +4785 48 6552 6553 +4786 48 6552 6554 +4787 48 6555 6556 +4788 48 6555 6557 +4789 48 6558 6559 +4790 48 6558 6560 +4791 48 6561 6562 +4792 48 6561 6563 +4793 48 6564 6565 +4794 48 6564 6566 +4795 48 6567 6568 +4796 48 6567 6569 +4797 48 6570 6571 +4798 48 6570 6572 +4799 48 6573 6574 +4800 48 6573 6575 +4801 48 6576 6577 +4802 48 6576 6578 +4803 48 6579 6580 +4804 48 6579 6581 +4805 48 6582 6583 +4806 48 6582 6584 +4807 48 6585 6586 +4808 48 6585 6587 +4809 48 6588 6589 +4810 48 6588 6590 +4811 48 6591 6592 +4812 48 6591 6593 +4813 48 6594 6595 +4814 48 6594 6596 +4815 48 6597 6598 +4816 48 6597 6599 +4817 48 6600 6601 +4818 48 6600 6602 +4819 48 6603 6604 +4820 48 6603 6605 +4821 48 6606 6607 +4822 48 6606 6608 +4823 48 6609 6610 +4824 48 6609 6611 +4825 48 6612 6613 +4826 48 6612 6614 +4827 48 6615 6616 +4828 48 6615 6617 +4829 48 6618 6619 +4830 48 6618 6620 +4831 48 6621 6622 +4832 48 6621 6623 +4833 48 6624 6625 +4834 48 6624 6626 +4835 48 6627 6628 +4836 48 6627 6629 +4837 48 6630 6631 +4838 48 6630 6632 +4839 48 6633 6634 +4840 48 6633 6635 +4841 48 6636 6637 +4842 48 6636 6638 +4843 48 6639 6640 +4844 48 6639 6641 +4845 48 6642 6643 +4846 48 6642 6644 +4847 48 6645 6646 +4848 48 6645 6647 +4849 48 6648 6649 +4850 48 6648 6650 +4851 48 6651 6652 +4852 48 6651 6653 +4853 48 6654 6655 +4854 48 6654 6656 +4855 48 6657 6658 +4856 48 6657 6659 +4857 48 6660 6661 +4858 48 6660 6662 +4859 48 6663 6664 +4860 48 6663 6665 +4861 48 6666 6667 +4862 48 6666 6668 +4863 48 6669 6670 +4864 48 6669 6671 +4865 48 6672 6673 +4866 48 6672 6674 +4867 48 6675 6676 +4868 48 6675 6677 +4869 48 6678 6679 +4870 48 6678 6680 +4871 48 6681 6682 +4872 48 6681 6683 +4873 48 6684 6685 +4874 48 6684 6686 +4875 48 6687 6688 +4876 48 6687 6689 +4877 48 6690 6691 +4878 48 6690 6692 +4879 48 6693 6694 +4880 48 6693 6695 +4881 48 6696 6697 +4882 48 6696 6698 +4883 48 6699 6700 +4884 48 6699 6701 +4885 48 6702 6703 +4886 48 6702 6704 +4887 48 6705 6706 +4888 48 6705 6707 +4889 48 6708 6709 +4890 48 6708 6710 +4891 48 6711 6712 +4892 48 6711 6713 +4893 48 6714 6715 +4894 48 6714 6716 +4895 48 6717 6718 +4896 48 6717 6719 +4897 48 6720 6721 +4898 48 6720 6722 +4899 48 6723 6724 +4900 48 6723 6725 +4901 48 6726 6727 +4902 48 6726 6728 +4903 48 6729 6730 +4904 48 6729 6731 +4905 48 6732 6733 +4906 48 6732 6734 +4907 48 6735 6736 +4908 48 6735 6737 +4909 48 6738 6739 +4910 48 6738 6740 +4911 48 6741 6742 +4912 48 6741 6743 +4913 48 6744 6745 +4914 48 6744 6746 +4915 48 6747 6748 +4916 48 6747 6749 +4917 48 6750 6751 +4918 48 6750 6752 +4919 48 6753 6754 +4920 48 6753 6755 +4921 48 6756 6757 +4922 48 6756 6758 +4923 48 6759 6760 +4924 48 6759 6761 +4925 48 6762 6763 +4926 48 6762 6764 +4927 48 6765 6766 +4928 48 6765 6767 +4929 48 6768 6769 +4930 48 6768 6770 +4931 48 6771 6772 +4932 48 6771 6773 +4933 48 6774 6775 +4934 48 6774 6776 +4935 48 6777 6778 +4936 48 6777 6779 +4937 48 6780 6781 +4938 48 6780 6782 +4939 48 6783 6784 +4940 48 6783 6785 +4941 48 6786 6787 +4942 48 6786 6788 +4943 48 6789 6790 +4944 48 6789 6791 +4945 48 6792 6793 +4946 48 6792 6794 +4947 48 6795 6796 +4948 48 6795 6797 +4949 48 6798 6799 +4950 48 6798 6800 +4951 48 6801 6802 +4952 48 6801 6803 +4953 48 6804 6805 +4954 48 6804 6806 +4955 48 6807 6808 +4956 48 6807 6809 +4957 48 6810 6811 +4958 48 6810 6812 +4959 48 6813 6814 +4960 48 6813 6815 +4961 48 6816 6817 +4962 48 6816 6818 +4963 48 6819 6820 +4964 48 6819 6821 +4965 48 6822 6823 +4966 48 6822 6824 +4967 48 6825 6826 +4968 48 6825 6827 +4969 48 6828 6829 +4970 48 6828 6830 +4971 48 6831 6832 +4972 48 6831 6833 +4973 48 6834 6835 +4974 48 6834 6836 +4975 48 6837 6838 +4976 48 6837 6839 +4977 48 6840 6841 +4978 48 6840 6842 +4979 48 6843 6844 +4980 48 6843 6845 +4981 48 6846 6847 +4982 48 6846 6848 +4983 48 6849 6850 +4984 48 6849 6851 +4985 48 6852 6853 +4986 48 6852 6854 +4987 48 6855 6856 +4988 48 6855 6857 +4989 48 6858 6859 +4990 48 6858 6860 +4991 48 6861 6862 +4992 48 6861 6863 +4993 48 6864 6865 +4994 48 6864 6866 +4995 48 6867 6868 +4996 48 6867 6869 +4997 48 6870 6871 +4998 48 6870 6872 +4999 48 6873 6874 +5000 48 6873 6875 +5001 48 6876 6877 +5002 48 6876 6878 +5003 48 6879 6880 +5004 48 6879 6881 +5005 48 6882 6883 +5006 48 6882 6884 +5007 48 6885 6886 +5008 48 6885 6887 +5009 48 6888 6889 +5010 48 6888 6890 +5011 48 6891 6892 +5012 48 6891 6893 +5013 48 6894 6895 +5014 48 6894 6896 +5015 48 6897 6898 +5016 48 6897 6899 +5017 48 6900 6901 +5018 48 6900 6902 +5019 48 6903 6904 +5020 48 6903 6905 +5021 48 6906 6907 +5022 48 6906 6908 +5023 48 6909 6910 +5024 48 6909 6911 +5025 48 6912 6913 +5026 48 6912 6914 +5027 48 6915 6916 +5028 48 6915 6917 +5029 48 6918 6919 +5030 48 6918 6920 +5031 48 6921 6922 +5032 48 6921 6923 +5033 48 6924 6925 +5034 48 6924 6926 +5035 48 6927 6928 +5036 48 6927 6929 +5037 48 6930 6931 +5038 48 6930 6932 +5039 48 6933 6934 +5040 48 6933 6935 +5041 48 6936 6937 +5042 48 6936 6938 +5043 48 6939 6940 +5044 48 6939 6941 +5045 48 6942 6943 +5046 48 6942 6944 +5047 48 6945 6946 +5048 48 6945 6947 +5049 48 6948 6949 +5050 48 6948 6950 +5051 48 6951 6952 +5052 48 6951 6953 +5053 48 6954 6955 +5054 48 6954 6956 +5055 48 6957 6958 +5056 48 6957 6959 +5057 48 6960 6961 +5058 48 6960 6962 +5059 48 6963 6964 +5060 48 6963 6965 +5061 48 6966 6967 +5062 48 6966 6968 +5063 48 6969 6970 +5064 48 6969 6971 +5065 48 6972 6973 +5066 48 6972 6974 +5067 48 6975 6976 +5068 48 6975 6977 +5069 48 6978 6979 +5070 48 6978 6980 +5071 48 6981 6982 +5072 48 6981 6983 +5073 48 6984 6985 +5074 48 6984 6986 +5075 48 6987 6988 +5076 48 6987 6989 +5077 48 6990 6991 +5078 48 6990 6992 +5079 48 6993 6994 +5080 48 6993 6995 +5081 48 6996 6997 +5082 48 6996 6998 +5083 48 6999 7000 +5084 48 6999 7001 +5085 48 7002 7003 +5086 48 7002 7004 +5087 48 7005 7006 +5088 48 7005 7007 +5089 48 7008 7009 +5090 48 7008 7010 +5091 48 7011 7012 +5092 48 7011 7013 +5093 48 7014 7015 +5094 48 7014 7016 +5095 48 7017 7018 +5096 48 7017 7019 +5097 48 7020 7021 +5098 48 7020 7022 +5099 48 7023 7024 +5100 48 7023 7025 +5101 48 7026 7027 +5102 48 7026 7028 +5103 48 7029 7030 +5104 48 7029 7031 +5105 48 7032 7033 +5106 48 7032 7034 +5107 48 7035 7036 +5108 48 7035 7037 +5109 48 7038 7039 +5110 48 7038 7040 +5111 48 7041 7042 +5112 48 7041 7043 +5113 48 7044 7045 +5114 48 7044 7046 +5115 48 7047 7048 +5116 48 7047 7049 +5117 48 7050 7051 +5118 48 7050 7052 +5119 48 7053 7054 +5120 48 7053 7055 +5121 48 7056 7057 +5122 48 7056 7058 +5123 48 7059 7060 +5124 48 7059 7061 +5125 48 7062 7063 +5126 48 7062 7064 +5127 48 7065 7066 +5128 48 7065 7067 +5129 48 7068 7069 +5130 48 7068 7070 +5131 48 7071 7072 +5132 48 7071 7073 +5133 48 7074 7075 +5134 48 7074 7076 +5135 48 7077 7078 +5136 48 7077 7079 +5137 48 7080 7081 +5138 48 7080 7082 +5139 48 7083 7084 +5140 48 7083 7085 +5141 48 7086 7087 +5142 48 7086 7088 +5143 48 7089 7090 +5144 48 7089 7091 +5145 48 7092 7093 +5146 48 7092 7094 +5147 48 7095 7096 +5148 48 7095 7097 +5149 48 7098 7099 +5150 48 7098 7100 +5151 48 7101 7102 +5152 48 7101 7103 +5153 48 7104 7105 +5154 48 7104 7106 +5155 48 7107 7108 +5156 48 7107 7109 +5157 48 7110 7111 +5158 48 7110 7112 +5159 48 7113 7114 +5160 48 7113 7115 +5161 48 7116 7117 +5162 48 7116 7118 +5163 48 7119 7120 +5164 48 7119 7121 +5165 48 7122 7123 +5166 48 7122 7124 +5167 48 7125 7126 +5168 48 7125 7127 +5169 48 7128 7129 +5170 48 7128 7130 +5171 48 7131 7132 +5172 48 7131 7133 +5173 48 7134 7135 +5174 48 7134 7136 +5175 48 7137 7138 +5176 48 7137 7139 +5177 48 7140 7141 +5178 48 7140 7142 +5179 48 7143 7144 +5180 48 7143 7145 +5181 48 7146 7147 +5182 48 7146 7148 +5183 48 7149 7150 +5184 48 7149 7151 +5185 48 7152 7153 +5186 48 7152 7154 +5187 48 7155 7156 +5188 48 7155 7157 +5189 48 7158 7159 +5190 48 7158 7160 +5191 48 7161 7162 +5192 48 7161 7163 +5193 48 7164 7165 +5194 48 7164 7166 +5195 48 7167 7168 +5196 48 7167 7169 +5197 48 7170 7171 +5198 48 7170 7172 +5199 48 7173 7174 +5200 48 7173 7175 +5201 48 7176 7177 +5202 48 7176 7178 +5203 48 7179 7180 +5204 48 7179 7181 +5205 48 7182 7183 +5206 48 7182 7184 +5207 48 7185 7186 +5208 48 7185 7187 +5209 48 7188 7189 +5210 48 7188 7190 +5211 48 7191 7192 +5212 48 7191 7193 +5213 48 7194 7195 +5214 48 7194 7196 +5215 48 7197 7198 +5216 48 7197 7199 +5217 48 7200 7201 +5218 48 7200 7202 +5219 48 7203 7204 +5220 48 7203 7205 +5221 48 7206 7207 +5222 48 7206 7208 +5223 48 7209 7210 +5224 48 7209 7211 +5225 48 7212 7213 +5226 48 7212 7214 +5227 48 7215 7216 +5228 48 7215 7217 +5229 48 7218 7219 +5230 48 7218 7220 +5231 48 7221 7222 +5232 48 7221 7223 +5233 48 7224 7225 +5234 48 7224 7226 +5235 48 7227 7228 +5236 48 7227 7229 +5237 48 7230 7231 +5238 48 7230 7232 +5239 48 7233 7234 +5240 48 7233 7235 +5241 48 7236 7237 +5242 48 7236 7238 +5243 48 7239 7240 +5244 48 7239 7241 +5245 48 7242 7243 +5246 48 7242 7244 +5247 48 7245 7246 +5248 48 7245 7247 +5249 48 7248 7249 +5250 48 7248 7250 +5251 48 7251 7252 +5252 48 7251 7253 +5253 48 7254 7255 +5254 48 7254 7256 +5255 48 7257 7258 +5256 48 7257 7259 +5257 48 7260 7261 +5258 48 7260 7262 +5259 48 7263 7264 +5260 48 7263 7265 +5261 48 7266 7267 +5262 48 7266 7268 +5263 48 7269 7270 +5264 48 7269 7271 +5265 48 7272 7273 +5266 48 7272 7274 +5267 48 7275 7276 +5268 48 7275 7277 +5269 48 7278 7279 +5270 48 7278 7280 +5271 48 7281 7282 +5272 48 7281 7283 +5273 48 7284 7285 +5274 48 7284 7286 +5275 48 7287 7288 +5276 48 7287 7289 +5277 48 7290 7291 +5278 48 7290 7292 +5279 48 7293 7294 +5280 48 7293 7295 +5281 48 7296 7297 +5282 48 7296 7298 +5283 48 7299 7300 +5284 48 7299 7301 +5285 48 7302 7303 +5286 48 7302 7304 +5287 48 7305 7306 +5288 48 7305 7307 +5289 48 7308 7309 +5290 48 7308 7310 +5291 48 7311 7312 +5292 48 7311 7313 +5293 48 7314 7315 +5294 48 7314 7316 +5295 48 7317 7318 +5296 48 7317 7319 +5297 48 7320 7321 +5298 48 7320 7322 +5299 48 7323 7324 +5300 48 7323 7325 +5301 48 7326 7327 +5302 48 7326 7328 +5303 48 7329 7330 +5304 48 7329 7331 +5305 48 7332 7333 +5306 48 7332 7334 +5307 48 7335 7336 +5308 48 7335 7337 +5309 48 7338 7339 +5310 48 7338 7340 +5311 48 7341 7342 +5312 48 7341 7343 +5313 48 7344 7345 +5314 48 7344 7346 +5315 48 7347 7348 +5316 48 7347 7349 +5317 48 7350 7351 +5318 48 7350 7352 +5319 48 7353 7354 +5320 48 7353 7355 +5321 48 7356 7357 +5322 48 7356 7358 +5323 48 7359 7360 +5324 48 7359 7361 +5325 48 7362 7363 +5326 48 7362 7364 +5327 48 7365 7366 +5328 48 7365 7367 +5329 48 7368 7369 +5330 48 7368 7370 +5331 48 7371 7372 +5332 48 7371 7373 +5333 48 7374 7375 +5334 48 7374 7376 +5335 48 7377 7378 +5336 48 7377 7379 +5337 48 7380 7381 +5338 48 7380 7382 +5339 48 7383 7384 +5340 48 7383 7385 +5341 48 7386 7387 +5342 48 7386 7388 +5343 48 7389 7390 +5344 48 7389 7391 +5345 48 7392 7393 +5346 48 7392 7394 +5347 48 7395 7396 +5348 48 7395 7397 +5349 48 7398 7399 +5350 48 7398 7400 +5351 48 7401 7402 +5352 48 7401 7403 +5353 48 7404 7405 +5354 48 7404 7406 +5355 48 7407 7408 +5356 48 7407 7409 +5357 48 7410 7411 +5358 48 7410 7412 +5359 48 7413 7414 +5360 48 7413 7415 +5361 48 7416 7417 +5362 48 7416 7418 +5363 48 7419 7420 +5364 48 7419 7421 +5365 48 7422 7423 +5366 48 7422 7424 +5367 48 7425 7426 +5368 48 7425 7427 +5369 48 7428 7429 +5370 48 7428 7430 +5371 48 7431 7432 +5372 48 7431 7433 +5373 48 7434 7435 +5374 48 7434 7436 +5375 48 7437 7438 +5376 48 7437 7439 +5377 48 7440 7441 +5378 48 7440 7442 +5379 48 7443 7444 +5380 48 7443 7445 +5381 48 7446 7447 +5382 48 7446 7448 +5383 48 7449 7450 +5384 48 7449 7451 +5385 48 7452 7453 +5386 48 7452 7454 +5387 48 7455 7456 +5388 48 7455 7457 +5389 48 7458 7459 +5390 48 7458 7460 +5391 48 7461 7462 +5392 48 7461 7463 +5393 48 7464 7465 +5394 48 7464 7466 +5395 48 7467 7468 +5396 48 7467 7469 +5397 48 7470 7471 +5398 48 7470 7472 +5399 48 7473 7474 +5400 48 7473 7475 +5401 48 7476 7477 +5402 48 7476 7478 +5403 48 7479 7480 +5404 48 7479 7481 +5405 48 7482 7483 +5406 48 7482 7484 +5407 48 7485 7486 +5408 48 7485 7487 +5409 48 7488 7489 +5410 48 7488 7490 +5411 48 7491 7492 +5412 48 7491 7493 +5413 48 7494 7495 +5414 48 7494 7496 +5415 48 7497 7498 +5416 48 7497 7499 +5417 48 7500 7501 +5418 48 7500 7502 +5419 48 7503 7504 +5420 48 7503 7505 +5421 48 7506 7507 +5422 48 7506 7508 +5423 48 7509 7510 +5424 48 7509 7511 +5425 48 7512 7513 +5426 48 7512 7514 +5427 48 7515 7516 +5428 48 7515 7517 +5429 48 7518 7519 +5430 48 7518 7520 +5431 48 7521 7522 +5432 48 7521 7523 +5433 48 7524 7525 +5434 48 7524 7526 +5435 48 7527 7528 +5436 48 7527 7529 +5437 48 7530 7531 +5438 48 7530 7532 +5439 48 7533 7534 +5440 48 7533 7535 +5441 48 7536 7537 +5442 48 7536 7538 +5443 48 7539 7540 +5444 48 7539 7541 +5445 48 7542 7543 +5446 48 7542 7544 +5447 48 7545 7546 +5448 48 7545 7547 +5449 48 7548 7549 +5450 48 7548 7550 +5451 48 7551 7552 +5452 48 7551 7553 +5453 48 7554 7555 +5454 48 7554 7556 +5455 48 7557 7558 +5456 48 7557 7559 +5457 48 7560 7561 +5458 48 7560 7562 +5459 48 7563 7564 +5460 48 7563 7565 +5461 48 7566 7567 +5462 48 7566 7568 +5463 48 7569 7570 +5464 48 7569 7571 +5465 48 7572 7573 +5466 48 7572 7574 +5467 48 7575 7576 +5468 48 7575 7577 +5469 48 7578 7579 +5470 48 7578 7580 +5471 48 7581 7582 +5472 48 7581 7583 +5473 48 7584 7585 +5474 48 7584 7586 +5475 48 7587 7588 +5476 48 7587 7589 +5477 48 7590 7591 +5478 48 7590 7592 +5479 48 7593 7594 +5480 48 7593 7595 +5481 48 7596 7597 +5482 48 7596 7598 +5483 48 7599 7600 +5484 48 7599 7601 +5485 48 7602 7603 +5486 48 7602 7604 +5487 48 7605 7606 +5488 48 7605 7607 +5489 48 7608 7609 +5490 48 7608 7610 +5491 48 7611 7612 +5492 48 7611 7613 +5493 48 7614 7615 +5494 48 7614 7616 +5495 48 7617 7618 +5496 48 7617 7619 +5497 48 7620 7621 +5498 48 7620 7622 +5499 48 7623 7624 +5500 48 7623 7625 +5501 48 7626 7627 +5502 48 7626 7628 +5503 48 7629 7630 +5504 48 7629 7631 +5505 48 7632 7633 +5506 48 7632 7634 +5507 48 7635 7636 +5508 48 7635 7637 +5509 48 7638 7639 +5510 48 7638 7640 +5511 48 7641 7642 +5512 48 7641 7643 +5513 48 7644 7645 +5514 48 7644 7646 +5515 48 7647 7648 +5516 48 7647 7649 +5517 48 7650 7651 +5518 48 7650 7652 +5519 48 7653 7654 +5520 48 7653 7655 +5521 48 7656 7657 +5522 48 7656 7658 +5523 48 7659 7660 +5524 48 7659 7661 +5525 48 7662 7663 +5526 48 7662 7664 +5527 48 7665 7666 +5528 48 7665 7667 +5529 48 7668 7669 +5530 48 7668 7670 +5531 48 7671 7672 +5532 48 7671 7673 +5533 48 7674 7675 +5534 48 7674 7676 +5535 48 7677 7678 +5536 48 7677 7679 +5537 48 7680 7681 +5538 48 7680 7682 +5539 48 7683 7684 +5540 48 7683 7685 +5541 48 7686 7687 +5542 48 7686 7688 +5543 48 7689 7690 +5544 48 7689 7691 +5545 48 7692 7693 +5546 48 7692 7694 +5547 48 7695 7696 +5548 48 7695 7697 +5549 48 7698 7699 +5550 48 7698 7700 +5551 48 7701 7702 +5552 48 7701 7703 +5553 48 7704 7705 +5554 48 7704 7706 +5555 48 7707 7708 +5556 48 7707 7709 +5557 48 7710 7711 +5558 48 7710 7712 +5559 48 7713 7714 +5560 48 7713 7715 +5561 48 7716 7717 +5562 48 7716 7718 +5563 48 7719 7720 +5564 48 7719 7721 +5565 48 7722 7723 +5566 48 7722 7724 +5567 48 7725 7726 +5568 48 7725 7727 +5569 48 7728 7729 +5570 48 7728 7730 +5571 48 7731 7732 +5572 48 7731 7733 +5573 48 7734 7735 +5574 48 7734 7736 +5575 48 7737 7738 +5576 48 7737 7739 +5577 48 7740 7741 +5578 48 7740 7742 +5579 48 7743 7744 +5580 48 7743 7745 +5581 48 7746 7747 +5582 48 7746 7748 +5583 48 7749 7750 +5584 48 7749 7751 +5585 48 7752 7753 +5586 48 7752 7754 +5587 48 7755 7756 +5588 48 7755 7757 +5589 48 7758 7759 +5590 48 7758 7760 +5591 48 7761 7762 +5592 48 7761 7763 +5593 48 7764 7765 +5594 48 7764 7766 +5595 48 7767 7768 +5596 48 7767 7769 +5597 48 7770 7771 +5598 48 7770 7772 +5599 48 7773 7774 +5600 48 7773 7775 +5601 48 7776 7777 +5602 48 7776 7778 +5603 48 7779 7780 +5604 48 7779 7781 +5605 48 7782 7783 +5606 48 7782 7784 +5607 48 7785 7786 +5608 48 7785 7787 +5609 48 7788 7789 +5610 48 7788 7790 +5611 48 7791 7792 +5612 48 7791 7793 +5613 48 7794 7795 +5614 48 7794 7796 +5615 48 7797 7798 +5616 48 7797 7799 +5617 48 7800 7801 +5618 48 7800 7802 +5619 48 7803 7804 +5620 48 7803 7805 +5621 48 7806 7807 +5622 48 7806 7808 +5623 48 7809 7810 +5624 48 7809 7811 +5625 48 7812 7813 +5626 48 7812 7814 +5627 48 7815 7816 +5628 48 7815 7817 +5629 48 7818 7819 +5630 48 7818 7820 +5631 48 7821 7822 +5632 48 7821 7823 +5633 48 7824 7825 +5634 48 7824 7826 +5635 48 7827 7828 +5636 48 7827 7829 +5637 48 7830 7831 +5638 48 7830 7832 +5639 48 7833 7834 +5640 48 7833 7835 +5641 48 7836 7837 +5642 48 7836 7838 +5643 48 7839 7840 +5644 48 7839 7841 +5645 48 7842 7843 +5646 48 7842 7844 +5647 48 7845 7846 +5648 48 7845 7847 +5649 48 7848 7849 +5650 48 7848 7850 +5651 48 7851 7852 +5652 48 7851 7853 +5653 48 7854 7855 +5654 48 7854 7856 +5655 48 7857 7858 +5656 48 7857 7859 +5657 48 7860 7861 +5658 48 7860 7862 +5659 48 7863 7864 +5660 48 7863 7865 +5661 48 7866 7867 +5662 48 7866 7868 +5663 48 7869 7870 +5664 48 7869 7871 +5665 48 7872 7873 +5666 48 7872 7874 +5667 48 7875 7876 +5668 48 7875 7877 +5669 48 7878 7879 +5670 48 7878 7880 +5671 48 7881 7882 +5672 48 7881 7883 +5673 48 7884 7885 +5674 48 7884 7886 +5675 48 7887 7888 +5676 48 7887 7889 +5677 48 7890 7891 +5678 48 7890 7892 +5679 48 7893 7894 +5680 48 7893 7895 +5681 48 7896 7897 +5682 48 7896 7898 +5683 48 7899 7900 +5684 48 7899 7901 +5685 48 7902 7903 +5686 48 7902 7904 +5687 48 7905 7906 +5688 48 7905 7907 +5689 48 7908 7909 +5690 48 7908 7910 +5691 48 7911 7912 +5692 48 7911 7913 +5693 48 7914 7915 +5694 48 7914 7916 +5695 48 7917 7918 +5696 48 7917 7919 +5697 48 7920 7921 +5698 48 7920 7922 +5699 48 7923 7924 +5700 48 7923 7925 +5701 48 7926 7927 +5702 48 7926 7928 +5703 48 7929 7930 +5704 48 7929 7931 +5705 48 7932 7933 +5706 48 7932 7934 +5707 48 7935 7936 +5708 48 7935 7937 +5709 48 7938 7939 +5710 48 7938 7940 +5711 48 7941 7942 +5712 48 7941 7943 +5713 48 7944 7945 +5714 48 7944 7946 +5715 48 7947 7948 +5716 48 7947 7949 +5717 48 7950 7951 +5718 48 7950 7952 +5719 48 7953 7954 +5720 48 7953 7955 +5721 48 7956 7957 +5722 48 7956 7958 +5723 48 7959 7960 +5724 48 7959 7961 +5725 48 7962 7963 +5726 48 7962 7964 +5727 48 7965 7966 +5728 48 7965 7967 +5729 48 7968 7969 +5730 48 7968 7970 +5731 48 7971 7972 +5732 48 7971 7973 +5733 48 7974 7975 +5734 48 7974 7976 +5735 48 7977 7978 +5736 48 7977 7979 +5737 48 7980 7981 +5738 48 7980 7982 +5739 48 7983 7984 +5740 48 7983 7985 +5741 48 7986 7987 +5742 48 7986 7988 +5743 48 7989 7990 +5744 48 7989 7991 +5745 48 7992 7993 +5746 48 7992 7994 +5747 48 7995 7996 +5748 48 7995 7997 +5749 48 7998 7999 +5750 48 7998 8000 +5751 48 8001 8002 +5752 48 8001 8003 +5753 48 8004 8005 +5754 48 8004 8006 +5755 48 8007 8008 +5756 48 8007 8009 +5757 48 8010 8011 +5758 48 8010 8012 +5759 48 8013 8014 +5760 48 8013 8015 +5761 48 8016 8017 +5762 48 8016 8018 +5763 48 8019 8020 +5764 48 8019 8021 +5765 48 8022 8023 +5766 48 8022 8024 +5767 48 8025 8026 +5768 48 8025 8027 +5769 48 8028 8029 +5770 48 8028 8030 +5771 48 8031 8032 +5772 48 8031 8033 +5773 48 8034 8035 +5774 48 8034 8036 +5775 48 8037 8038 +5776 48 8037 8039 +5777 48 8040 8041 +5778 48 8040 8042 +5779 48 8043 8044 +5780 48 8043 8045 +5781 48 8046 8047 +5782 48 8046 8048 +5783 48 8049 8050 +5784 48 8049 8051 +5785 48 8052 8053 +5786 48 8052 8054 +5787 48 8055 8056 +5788 48 8055 8057 +5789 48 8058 8059 +5790 48 8058 8060 +5791 48 8061 8062 +5792 48 8061 8063 +5793 48 8064 8065 +5794 48 8064 8066 +5795 48 8067 8068 +5796 48 8067 8069 +5797 48 8070 8071 +5798 48 8070 8072 +5799 48 8073 8074 +5800 48 8073 8075 +5801 48 8076 8077 +5802 48 8076 8078 +5803 48 8079 8080 +5804 48 8079 8081 +5805 48 8082 8083 +5806 48 8082 8084 +5807 48 8085 8086 +5808 48 8085 8087 +5809 48 8088 8089 +5810 48 8088 8090 +5811 48 8091 8092 +5812 48 8091 8093 +5813 48 8094 8095 +5814 48 8094 8096 +5815 48 8097 8098 +5816 48 8097 8099 +5817 48 8100 8101 +5818 48 8100 8102 +5819 48 8103 8104 +5820 48 8103 8105 +5821 48 8106 8107 +5822 48 8106 8108 +5823 48 8109 8110 +5824 48 8109 8111 +5825 48 8112 8113 +5826 48 8112 8114 +5827 48 8115 8116 +5828 48 8115 8117 +5829 48 8118 8119 +5830 48 8118 8120 +5831 48 8121 8122 +5832 48 8121 8123 +5833 48 8124 8125 +5834 48 8124 8126 +5835 48 8127 8128 +5836 48 8127 8129 +5837 48 8130 8131 +5838 48 8130 8132 +5839 48 8133 8134 +5840 48 8133 8135 +5841 48 8136 8137 +5842 48 8136 8138 +5843 48 8139 8140 +5844 48 8139 8141 +5845 48 8142 8143 +5846 48 8142 8144 +5847 48 8145 8146 +5848 48 8145 8147 +5849 48 8148 8149 +5850 48 8148 8150 +5851 48 8151 8152 +5852 48 8151 8153 +5853 48 8154 8155 +5854 48 8154 8156 +5855 48 8157 8158 +5856 48 8157 8159 +5857 48 8160 8161 +5858 48 8160 8162 +5859 48 8163 8164 +5860 48 8163 8165 +5861 48 8166 8167 +5862 48 8166 8168 +5863 48 8169 8170 +5864 48 8169 8171 +5865 48 8172 8173 +5866 48 8172 8174 +5867 48 8175 8176 +5868 48 8175 8177 +5869 48 8178 8179 +5870 48 8178 8180 +5871 48 8181 8182 +5872 48 8181 8183 +5873 48 8184 8185 +5874 48 8184 8186 +5875 48 8187 8188 +5876 48 8187 8189 +5877 48 8190 8191 +5878 48 8190 8192 +5879 48 8193 8194 +5880 48 8193 8195 +5881 48 8196 8197 +5882 48 8196 8198 +5883 48 8199 8200 +5884 48 8199 8201 +5885 48 8202 8203 +5886 48 8202 8204 +5887 48 8205 8206 +5888 48 8205 8207 +5889 48 8208 8209 +5890 48 8208 8210 +5891 48 8211 8212 +5892 48 8211 8213 +5893 48 8214 8215 +5894 48 8214 8216 +5895 48 8217 8218 +5896 48 8217 8219 +5897 48 8220 8221 +5898 48 8220 8222 +5899 48 8223 8224 +5900 48 8223 8225 +5901 48 8226 8227 +5902 48 8226 8228 +5903 48 8229 8230 +5904 48 8229 8231 +5905 48 8232 8233 +5906 48 8232 8234 +5907 48 8235 8236 +5908 48 8235 8237 +5909 48 8238 8239 +5910 48 8238 8240 +5911 48 8241 8242 +5912 48 8241 8243 +5913 48 8244 8245 +5914 48 8244 8246 +5915 48 8247 8248 +5916 48 8247 8249 +5917 48 8250 8251 +5918 48 8250 8252 +5919 48 8253 8254 +5920 48 8253 8255 +5921 48 8256 8257 +5922 48 8256 8258 +5923 48 8259 8260 +5924 48 8259 8261 +5925 48 8262 8263 +5926 48 8262 8264 +5927 48 8265 8266 +5928 48 8265 8267 +5929 48 8268 8269 +5930 48 8268 8270 +5931 48 8271 8272 +5932 48 8271 8273 +5933 48 8274 8275 +5934 48 8274 8276 +5935 48 8277 8278 +5936 48 8277 8279 +5937 48 8280 8281 +5938 48 8280 8282 +5939 48 8283 8284 +5940 48 8283 8285 +5941 48 8286 8287 +5942 48 8286 8288 +5943 48 8289 8290 +5944 48 8289 8291 +5945 48 8292 8293 +5946 48 8292 8294 +5947 48 8295 8296 +5948 48 8295 8297 +5949 48 8298 8299 +5950 48 8298 8300 +5951 48 8301 8302 +5952 48 8301 8303 +5953 48 8304 8305 +5954 48 8304 8306 +5955 48 8307 8308 +5956 48 8307 8309 +5957 48 8310 8311 +5958 48 8310 8312 +5959 48 8313 8314 +5960 48 8313 8315 +5961 48 8316 8317 +5962 48 8316 8318 +5963 48 8319 8320 +5964 48 8319 8321 +5965 48 8322 8323 +5966 48 8322 8324 +5967 48 8325 8326 +5968 48 8325 8327 +5969 48 8328 8329 +5970 48 8328 8330 +5971 48 8331 8332 +5972 48 8331 8333 +5973 48 8334 8335 +5974 48 8334 8336 +5975 48 8337 8338 +5976 48 8337 8339 +5977 48 8340 8341 +5978 48 8340 8342 +5979 48 8343 8344 +5980 48 8343 8345 +5981 48 8346 8347 +5982 48 8346 8348 +5983 48 8349 8350 +5984 48 8349 8351 +5985 48 8352 8353 +5986 48 8352 8354 +5987 48 8355 8356 +5988 48 8355 8357 +5989 48 8358 8359 +5990 48 8358 8360 +5991 48 8361 8362 +5992 48 8361 8363 +5993 48 8364 8365 +5994 48 8364 8366 +5995 48 8367 8368 +5996 48 8367 8369 +5997 48 8370 8371 +5998 48 8370 8372 +5999 48 8373 8374 +6000 48 8373 8375 +6001 48 8376 8377 +6002 48 8376 8378 +6003 48 8379 8380 +6004 48 8379 8381 +6005 48 8382 8383 +6006 48 8382 8384 +6007 48 8385 8386 +6008 48 8385 8387 +6009 48 8388 8389 +6010 48 8388 8390 +6011 48 8391 8392 +6012 48 8391 8393 +6013 48 8394 8395 +6014 48 8394 8396 +6015 48 8397 8398 +6016 48 8397 8399 +6017 48 8400 8401 +6018 48 8400 8402 +6019 48 8403 8404 +6020 48 8403 8405 +6021 48 8406 8407 +6022 48 8406 8408 +6023 48 8409 8410 +6024 48 8409 8411 +6025 48 8412 8413 +6026 48 8412 8414 +6027 48 8415 8416 +6028 48 8415 8417 +6029 48 8418 8419 +6030 48 8418 8420 +6031 48 8421 8422 +6032 48 8421 8423 +6033 48 8424 8425 +6034 48 8424 8426 +6035 48 8427 8428 +6036 48 8427 8429 +6037 48 8430 8431 +6038 48 8430 8432 +6039 48 8433 8434 +6040 48 8433 8435 +6041 48 8436 8437 +6042 48 8436 8438 +6043 48 8439 8440 +6044 48 8439 8441 +6045 48 8442 8443 +6046 48 8442 8444 +6047 48 8445 8446 +6048 48 8445 8447 +6049 48 8448 8449 +6050 48 8448 8450 +6051 48 8451 8452 +6052 48 8451 8453 +6053 48 8454 8455 +6054 48 8454 8456 +6055 48 8457 8458 +6056 48 8457 8459 +6057 48 8460 8461 +6058 48 8460 8462 +6059 48 8463 8464 +6060 48 8463 8465 +6061 48 8466 8467 +6062 48 8466 8468 +6063 48 8469 8470 +6064 48 8469 8471 +6065 48 8472 8473 +6066 48 8472 8474 +6067 48 8475 8476 +6068 48 8475 8477 +6069 48 8478 8479 +6070 48 8478 8480 +6071 48 8481 8482 +6072 48 8481 8483 +6073 48 8484 8485 +6074 48 8484 8486 +6075 48 8487 8488 +6076 48 8487 8489 +6077 48 8490 8491 +6078 48 8490 8492 +6079 48 8493 8494 +6080 48 8493 8495 +6081 48 8496 8497 +6082 48 8496 8498 +6083 48 8499 8500 +6084 48 8499 8501 +6085 48 8502 8503 +6086 48 8502 8504 +6087 48 8505 8506 +6088 48 8505 8507 +6089 48 8508 8509 +6090 48 8508 8510 +6091 48 8511 8512 +6092 48 8511 8513 +6093 48 8514 8515 +6094 48 8514 8516 +6095 48 8517 8518 +6096 48 8517 8519 +6097 48 8520 8521 +6098 48 8520 8522 +6099 48 8523 8524 +6100 48 8523 8525 +6101 48 8526 8527 +6102 48 8526 8528 +6103 48 8529 8530 +6104 48 8529 8531 +6105 48 8532 8533 +6106 48 8532 8534 +6107 48 8535 8536 +6108 48 8535 8537 +6109 48 8538 8539 +6110 48 8538 8540 +6111 48 8541 8542 +6112 48 8541 8543 +6113 48 8544 8545 +6114 48 8544 8546 +6115 48 8547 8548 +6116 48 8547 8549 +6117 48 8550 8551 +6118 48 8550 8552 +6119 48 8553 8554 +6120 48 8553 8555 +6121 48 8556 8557 +6122 48 8556 8558 +6123 48 8559 8560 +6124 48 8559 8561 +6125 48 8562 8563 +6126 48 8562 8564 +6127 48 8565 8566 +6128 48 8565 8567 +6129 48 8568 8569 +6130 48 8568 8570 +6131 48 8571 8572 +6132 48 8571 8573 +6133 48 8574 8575 +6134 48 8574 8576 +6135 48 8577 8578 +6136 48 8577 8579 +6137 48 8580 8581 +6138 48 8580 8582 +6139 48 8583 8584 +6140 48 8583 8585 +6141 48 8586 8587 +6142 48 8586 8588 +6143 48 8589 8590 +6144 48 8589 8591 +6145 48 8592 8593 +6146 48 8592 8594 +6147 48 8595 8596 +6148 48 8595 8597 +6149 48 8598 8599 +6150 48 8598 8600 +6151 48 8601 8602 +6152 48 8601 8603 +6153 48 8604 8605 +6154 48 8604 8606 +6155 48 8607 8608 +6156 48 8607 8609 +6157 48 8610 8611 +6158 48 8610 8612 +6159 48 8613 8614 +6160 48 8613 8615 +6161 48 8616 8617 +6162 48 8616 8618 +6163 48 8619 8620 +6164 48 8619 8621 +6165 48 8622 8623 +6166 48 8622 8624 +6167 48 8625 8626 +6168 48 8625 8627 +6169 48 8628 8629 +6170 48 8628 8630 +6171 48 8631 8632 +6172 48 8631 8633 +6173 48 8634 8635 +6174 48 8634 8636 +6175 48 8637 8638 +6176 48 8637 8639 +6177 48 8640 8641 +6178 48 8640 8642 +6179 48 8643 8644 +6180 48 8643 8645 +6181 48 8646 8647 +6182 48 8646 8648 +6183 48 8649 8650 +6184 48 8649 8651 +6185 48 8652 8653 +6186 48 8652 8654 +6187 48 8655 8656 +6188 48 8655 8657 +6189 48 8658 8659 +6190 48 8658 8660 +6191 48 8661 8662 +6192 48 8661 8663 +6193 48 8664 8665 +6194 48 8664 8666 +6195 48 8667 8668 +6196 48 8667 8669 +6197 48 8670 8671 +6198 48 8670 8672 +6199 48 8673 8674 +6200 48 8673 8675 +6201 48 8676 8677 +6202 48 8676 8678 +6203 48 8679 8680 +6204 48 8679 8681 +6205 48 8682 8683 +6206 48 8682 8684 +6207 48 8685 8686 +6208 48 8685 8687 +6209 48 8688 8689 +6210 48 8688 8690 +6211 48 8691 8692 +6212 48 8691 8693 +6213 48 8694 8695 +6214 48 8694 8696 +6215 48 8697 8698 +6216 48 8697 8699 +6217 48 8700 8701 +6218 48 8700 8702 +6219 48 8703 8704 +6220 48 8703 8705 +6221 48 8706 8707 +6222 48 8706 8708 +6223 48 8709 8710 +6224 48 8709 8711 +6225 48 8712 8713 +6226 48 8712 8714 +6227 48 8715 8716 +6228 48 8715 8717 +6229 48 8718 8719 +6230 48 8718 8720 +6231 48 8721 8722 +6232 48 8721 8723 +6233 48 8724 8725 +6234 48 8724 8726 +6235 48 8727 8728 +6236 48 8727 8729 +6237 48 8730 8731 +6238 48 8730 8732 +6239 48 8733 8734 +6240 48 8733 8735 +6241 48 8736 8737 +6242 48 8736 8738 +6243 48 8739 8740 +6244 48 8739 8741 +6245 48 8742 8743 +6246 48 8742 8744 +6247 48 8745 8746 +6248 48 8745 8747 +6249 48 8748 8749 +6250 48 8748 8750 +6251 48 8751 8752 +6252 48 8751 8753 +6253 48 8754 8755 +6254 48 8754 8756 +6255 48 8757 8758 +6256 48 8757 8759 +6257 48 8760 8761 +6258 48 8760 8762 +6259 48 8763 8764 +6260 48 8763 8765 +6261 48 8766 8767 +6262 48 8766 8768 +6263 48 8769 8770 +6264 48 8769 8771 +6265 48 8772 8773 +6266 48 8772 8774 +6267 48 8775 8776 +6268 48 8775 8777 +6269 48 8778 8779 +6270 48 8778 8780 +6271 48 8781 8782 +6272 48 8781 8783 +6273 48 8784 8785 +6274 48 8784 8786 +6275 48 8787 8788 +6276 48 8787 8789 +6277 48 8790 8791 +6278 48 8790 8792 +6279 48 8793 8794 +6280 48 8793 8795 +6281 48 8796 8797 +6282 48 8796 8798 +6283 48 8799 8800 +6284 48 8799 8801 +6285 48 8802 8803 +6286 48 8802 8804 +6287 48 8805 8806 +6288 48 8805 8807 +6289 48 8808 8809 +6290 48 8808 8810 +6291 48 8811 8812 +6292 48 8811 8813 +6293 48 8814 8815 +6294 48 8814 8816 +6295 48 8817 8818 +6296 48 8817 8819 +6297 48 8820 8821 +6298 48 8820 8822 +6299 48 8823 8824 +6300 48 8823 8825 +6301 48 8826 8827 +6302 48 8826 8828 +6303 48 8829 8830 +6304 48 8829 8831 +6305 48 8832 8833 +6306 48 8832 8834 +6307 48 8835 8836 +6308 48 8835 8837 +6309 48 8838 8839 +6310 48 8838 8840 +6311 48 8841 8842 +6312 48 8841 8843 +6313 48 8844 8845 +6314 48 8844 8846 +6315 48 8847 8848 +6316 48 8847 8849 +6317 48 8850 8851 +6318 48 8850 8852 +6319 48 8853 8854 +6320 48 8853 8855 +6321 48 8856 8857 +6322 48 8856 8858 +6323 48 8859 8860 +6324 48 8859 8861 +6325 48 8862 8863 +6326 48 8862 8864 +6327 48 8865 8866 +6328 48 8865 8867 +6329 48 8868 8869 +6330 48 8868 8870 +6331 48 8871 8872 +6332 48 8871 8873 +6333 48 8874 8875 +6334 48 8874 8876 +6335 48 8877 8878 +6336 48 8877 8879 +6337 48 8880 8881 +6338 48 8880 8882 +6339 48 8883 8884 +6340 48 8883 8885 +6341 48 8886 8887 +6342 48 8886 8888 +6343 48 8889 8890 +6344 48 8889 8891 +6345 48 8892 8893 +6346 48 8892 8894 +6347 48 8895 8896 +6348 48 8895 8897 +6349 48 8898 8899 +6350 48 8898 8900 +6351 48 8901 8902 +6352 48 8901 8903 +6353 48 8904 8905 +6354 48 8904 8906 +6355 48 8907 8908 +6356 48 8907 8909 +6357 48 8910 8911 +6358 48 8910 8912 +6359 48 8913 8914 +6360 48 8913 8915 +6361 48 8916 8917 +6362 48 8916 8918 +6363 48 8919 8920 +6364 48 8919 8921 +6365 48 8922 8923 +6366 48 8922 8924 +6367 48 8925 8926 +6368 48 8925 8927 +6369 48 8928 8929 +6370 48 8928 8930 +6371 48 8931 8932 +6372 48 8931 8933 +6373 48 8934 8935 +6374 48 8934 8936 +6375 48 8937 8938 +6376 48 8937 8939 +6377 48 8940 8941 +6378 48 8940 8942 +6379 48 8943 8944 +6380 48 8943 8945 +6381 48 8946 8947 +6382 48 8946 8948 +6383 48 8949 8950 +6384 48 8949 8951 +6385 48 8952 8953 +6386 48 8952 8954 +6387 48 8955 8956 +6388 48 8955 8957 +6389 48 8958 8959 +6390 48 8958 8960 +6391 48 8961 8962 +6392 48 8961 8963 +6393 48 8964 8965 +6394 48 8964 8966 +6395 48 8967 8968 +6396 48 8967 8969 +6397 48 8970 8971 +6398 48 8970 8972 +6399 48 8973 8974 +6400 48 8973 8975 +6401 48 8976 8977 +6402 48 8976 8978 +6403 48 8979 8980 +6404 48 8979 8981 +6405 48 8982 8983 +6406 48 8982 8984 +6407 48 8985 8986 +6408 48 8985 8987 +6409 48 8988 8989 +6410 48 8988 8990 +6411 48 8991 8992 +6412 48 8991 8993 +6413 48 8994 8995 +6414 48 8994 8996 +6415 48 8997 8998 +6416 48 8997 8999 +6417 48 9000 9001 +6418 48 9000 9002 +6419 48 9003 9004 +6420 48 9003 9005 +6421 48 9006 9007 +6422 48 9006 9008 +6423 48 9009 9010 +6424 48 9009 9011 +6425 48 9012 9013 +6426 48 9012 9014 +6427 48 9015 9016 +6428 48 9015 9017 +6429 48 9018 9019 +6430 48 9018 9020 +6431 48 9021 9022 +6432 48 9021 9023 +6433 48 9024 9025 +6434 48 9024 9026 +6435 48 9027 9028 +6436 48 9027 9029 +6437 48 9030 9031 +6438 48 9030 9032 +6439 48 9033 9034 +6440 48 9033 9035 +6441 48 9036 9037 +6442 48 9036 9038 +6443 48 9039 9040 +6444 48 9039 9041 +6445 48 9042 9043 +6446 48 9042 9044 +6447 48 9045 9046 +6448 48 9045 9047 +6449 48 9048 9049 +6450 48 9048 9050 +6451 48 9051 9052 +6452 48 9051 9053 +6453 48 9054 9055 +6454 48 9054 9056 +6455 48 9057 9058 +6456 48 9057 9059 +6457 48 9060 9061 +6458 48 9060 9062 +6459 48 9063 9064 +6460 48 9063 9065 +6461 48 9066 9067 +6462 48 9066 9068 +6463 48 9069 9070 +6464 48 9069 9071 +6465 48 9072 9073 +6466 48 9072 9074 +6467 48 9075 9076 +6468 48 9075 9077 +6469 48 9078 9079 +6470 48 9078 9080 +6471 48 9081 9082 +6472 48 9081 9083 +6473 48 9084 9085 +6474 48 9084 9086 +6475 48 9087 9088 +6476 48 9087 9089 +6477 48 9090 9091 +6478 48 9090 9092 +6479 48 9093 9094 +6480 48 9093 9095 +6481 48 9096 9097 +6482 48 9096 9098 +6483 48 9099 9100 +6484 48 9099 9101 +6485 48 9102 9103 +6486 48 9102 9104 +6487 48 9105 9106 +6488 48 9105 9107 +6489 48 9108 9109 +6490 48 9108 9110 +6491 48 9111 9112 +6492 48 9111 9113 +6493 48 9114 9115 +6494 48 9114 9116 +6495 48 9117 9118 +6496 48 9117 9119 +6497 48 9120 9121 +6498 48 9120 9122 +6499 48 9123 9124 +6500 48 9123 9125 +6501 48 9126 9127 +6502 48 9126 9128 +6503 48 9129 9130 +6504 48 9129 9131 +6505 48 9132 9133 +6506 48 9132 9134 +6507 48 9135 9136 +6508 48 9135 9137 +6509 48 9138 9139 +6510 48 9138 9140 +6511 48 9141 9142 +6512 48 9141 9143 +6513 48 9144 9145 +6514 48 9144 9146 +6515 48 9147 9148 +6516 48 9147 9149 +6517 48 9150 9151 +6518 48 9150 9152 +6519 48 9153 9154 +6520 48 9153 9155 +6521 48 9156 9157 +6522 48 9156 9158 +6523 48 9159 9160 +6524 48 9159 9161 +6525 48 9162 9163 +6526 48 9162 9164 +6527 48 9165 9166 +6528 48 9165 9167 +6529 48 9168 9169 +6530 48 9168 9170 +6531 48 9171 9172 +6532 48 9171 9173 +6533 48 9174 9175 +6534 48 9174 9176 +6535 48 9177 9178 +6536 48 9177 9179 +6537 48 9180 9181 +6538 48 9180 9182 +6539 48 9183 9184 +6540 48 9183 9185 +6541 48 9186 9187 +6542 48 9186 9188 +6543 48 9189 9190 +6544 48 9189 9191 +6545 48 9192 9193 +6546 48 9192 9194 +6547 48 9195 9196 +6548 48 9195 9197 +6549 48 9198 9199 +6550 48 9198 9200 +6551 48 9201 9202 +6552 48 9201 9203 +6553 48 9204 9205 +6554 48 9204 9206 +6555 48 9207 9208 +6556 48 9207 9209 +6557 48 9210 9211 +6558 48 9210 9212 +6559 48 9213 9214 +6560 48 9213 9215 +6561 48 9216 9217 +6562 48 9216 9218 +6563 48 9219 9220 +6564 48 9219 9221 +6565 48 9222 9223 +6566 48 9222 9224 +6567 48 9225 9226 +6568 48 9225 9227 +6569 48 9228 9229 +6570 48 9228 9230 +6571 48 9231 9232 +6572 48 9231 9233 +6573 48 9234 9235 +6574 48 9234 9236 +6575 48 9237 9238 +6576 48 9237 9239 +6577 48 9240 9241 +6578 48 9240 9242 +6579 48 9243 9244 +6580 48 9243 9245 +6581 48 9246 9247 +6582 48 9246 9248 +6583 48 9249 9250 +6584 48 9249 9251 +6585 48 9252 9253 +6586 48 9252 9254 +6587 48 9255 9256 +6588 48 9255 9257 +6589 48 9258 9259 +6590 48 9258 9260 +6591 48 9261 9262 +6592 48 9261 9263 +6593 48 9264 9265 +6594 48 9264 9266 +6595 48 9267 9268 +6596 48 9267 9269 +6597 48 9270 9271 +6598 48 9270 9272 +6599 48 9273 9274 +6600 48 9273 9275 +6601 48 9276 9277 +6602 48 9276 9278 +6603 48 9279 9280 +6604 48 9279 9281 +6605 48 9282 9283 +6606 48 9282 9284 +6607 48 9285 9286 +6608 48 9285 9287 +6609 48 9288 9289 +6610 48 9288 9290 +6611 48 9291 9292 +6612 48 9291 9293 +6613 48 9294 9295 +6614 48 9294 9296 +6615 48 9297 9298 +6616 48 9297 9299 +6617 48 9300 9301 +6618 48 9300 9302 +6619 48 9303 9304 +6620 48 9303 9305 +6621 48 9306 9307 +6622 48 9306 9308 +6623 48 9309 9310 +6624 48 9309 9311 +6625 48 9312 9313 +6626 48 9312 9314 +6627 48 9315 9316 +6628 48 9315 9317 +6629 48 9318 9319 +6630 48 9318 9320 +6631 48 9321 9322 +6632 48 9321 9323 +6633 48 9324 9325 +6634 48 9324 9326 +6635 48 9327 9328 +6636 48 9327 9329 +6637 48 9330 9331 +6638 48 9330 9332 +6639 48 9333 9334 +6640 48 9333 9335 +6641 48 9336 9337 +6642 48 9336 9338 +6643 48 9339 9340 +6644 48 9339 9341 +6645 48 9342 9343 +6646 48 9342 9344 +6647 48 9345 9346 +6648 48 9345 9347 +6649 48 9348 9349 +6650 48 9348 9350 +6651 48 9351 9352 +6652 48 9351 9353 +6653 48 9354 9355 +6654 48 9354 9356 +6655 48 9357 9358 +6656 48 9357 9359 +6657 48 9360 9361 +6658 48 9360 9362 +6659 48 9363 9364 +6660 48 9363 9365 +6661 48 9366 9367 +6662 48 9366 9368 +6663 48 9369 9370 +6664 48 9369 9371 +6665 48 9372 9373 +6666 48 9372 9374 +6667 48 9375 9376 +6668 48 9375 9377 +6669 48 9378 9379 +6670 48 9378 9380 +6671 48 9381 9382 +6672 48 9381 9383 +6673 48 9384 9385 +6674 48 9384 9386 +6675 48 9387 9388 +6676 48 9387 9389 +6677 48 9390 9391 +6678 48 9390 9392 +6679 48 9393 9394 +6680 48 9393 9395 +6681 48 9396 9397 +6682 48 9396 9398 +6683 48 9399 9400 +6684 48 9399 9401 +6685 48 9402 9403 +6686 48 9402 9404 +6687 48 9405 9406 +6688 48 9405 9407 +6689 48 9408 9409 +6690 48 9408 9410 +6691 48 9411 9412 +6692 48 9411 9413 +6693 48 9414 9415 +6694 48 9414 9416 +6695 48 9417 9418 +6696 48 9417 9419 +6697 48 9420 9421 +6698 48 9420 9422 +6699 48 9423 9424 +6700 48 9423 9425 +6701 48 9426 9427 +6702 48 9426 9428 +6703 48 9429 9430 +6704 48 9429 9431 +6705 48 9432 9433 +6706 48 9432 9434 +6707 48 9435 9436 +6708 48 9435 9437 +6709 48 9438 9439 +6710 48 9438 9440 +6711 48 9441 9442 +6712 48 9441 9443 +6713 48 9444 9445 +6714 48 9444 9446 +6715 48 9447 9448 +6716 48 9447 9449 +6717 48 9450 9451 +6718 48 9450 9452 +6719 48 9453 9454 +6720 48 9453 9455 +6721 48 9456 9457 +6722 48 9456 9458 +6723 48 9459 9460 +6724 48 9459 9461 +6725 48 9462 9463 +6726 48 9462 9464 +6727 48 9465 9466 +6728 48 9465 9467 +6729 48 9468 9469 +6730 48 9468 9470 +6731 48 9471 9472 +6732 48 9471 9473 +6733 48 9474 9475 +6734 48 9474 9476 +6735 48 9477 9478 +6736 48 9477 9479 +6737 48 9480 9481 +6738 48 9480 9482 +6739 48 9483 9484 +6740 48 9483 9485 +6741 48 9486 9487 +6742 48 9486 9488 +6743 48 9489 9490 +6744 48 9489 9491 +6745 48 9492 9493 +6746 48 9492 9494 +6747 48 9495 9496 +6748 48 9495 9497 +6749 48 9498 9499 +6750 48 9498 9500 +6751 48 9501 9502 +6752 48 9501 9503 +6753 48 9504 9505 +6754 48 9504 9506 +6755 48 9507 9508 +6756 48 9507 9509 +6757 48 9510 9511 +6758 48 9510 9512 +6759 48 9513 9514 +6760 48 9513 9515 +6761 48 9516 9517 +6762 48 9516 9518 +6763 48 9519 9520 +6764 48 9519 9521 +6765 48 9522 9523 +6766 48 9522 9524 +6767 48 9525 9526 +6768 48 9525 9527 +6769 48 9528 9529 +6770 48 9528 9530 +6771 48 9531 9532 +6772 48 9531 9533 +6773 48 9534 9535 +6774 48 9534 9536 +6775 48 9537 9538 +6776 48 9537 9539 +6777 48 9540 9541 +6778 48 9540 9542 +6779 48 9543 9544 +6780 48 9543 9545 +6781 48 9546 9547 +6782 48 9546 9548 +6783 48 9549 9550 +6784 48 9549 9551 +6785 48 9552 9553 +6786 48 9552 9554 +6787 48 9555 9556 +6788 48 9555 9557 +6789 48 9558 9559 +6790 48 9558 9560 +6791 48 9561 9562 +6792 48 9561 9563 +6793 48 9564 9565 +6794 48 9564 9566 +6795 48 9567 9568 +6796 48 9567 9569 +6797 48 9570 9571 +6798 48 9570 9572 +6799 48 9573 9574 +6800 48 9573 9575 +6801 48 9576 9577 +6802 48 9576 9578 +6803 48 9579 9580 +6804 48 9579 9581 +6805 48 9582 9583 +6806 48 9582 9584 +6807 48 9585 9586 +6808 48 9585 9587 +6809 48 9588 9589 +6810 48 9588 9590 +6811 48 9591 9592 +6812 48 9591 9593 +6813 48 9594 9595 +6814 48 9594 9596 +6815 48 9597 9598 +6816 48 9597 9599 +6817 48 9600 9601 +6818 48 9600 9602 +6819 48 9603 9604 +6820 48 9603 9605 +6821 48 9606 9607 +6822 48 9606 9608 +6823 48 9609 9610 +6824 48 9609 9611 +6825 48 9612 9613 +6826 48 9612 9614 +6827 48 9615 9616 +6828 48 9615 9617 +6829 48 9618 9619 +6830 48 9618 9620 +6831 48 9621 9622 +6832 48 9621 9623 +6833 48 9624 9625 +6834 48 9624 9626 +6835 48 9627 9628 +6836 48 9627 9629 +6837 48 9630 9631 +6838 48 9630 9632 +6839 48 9633 9634 +6840 48 9633 9635 +6841 48 9636 9637 +6842 48 9636 9638 +6843 48 9639 9640 +6844 48 9639 9641 +6845 48 9642 9643 +6846 48 9642 9644 +6847 48 9645 9646 +6848 48 9645 9647 +6849 48 9648 9649 +6850 48 9648 9650 +6851 48 9651 9652 +6852 48 9651 9653 +6853 48 9654 9655 +6854 48 9654 9656 +6855 48 9657 9658 +6856 48 9657 9659 +6857 48 9660 9661 +6858 48 9660 9662 +6859 48 9663 9664 +6860 48 9663 9665 +6861 48 9666 9667 +6862 48 9666 9668 +6863 48 9669 9670 +6864 48 9669 9671 +6865 48 9672 9673 +6866 48 9672 9674 +6867 48 9675 9676 +6868 48 9675 9677 +6869 48 9678 9679 +6870 48 9678 9680 +6871 48 9681 9682 +6872 48 9681 9683 +6873 48 9684 9685 +6874 48 9684 9686 +6875 48 9687 9688 +6876 48 9687 9689 +6877 48 9690 9691 +6878 48 9690 9692 +6879 48 9693 9694 +6880 48 9693 9695 +6881 48 9696 9697 +6882 48 9696 9698 +6883 48 9699 9700 +6884 48 9699 9701 +6885 48 9702 9703 +6886 48 9702 9704 +6887 48 9705 9706 +6888 48 9705 9707 +6889 48 9708 9709 +6890 48 9708 9710 +6891 48 9711 9712 +6892 48 9711 9713 +6893 48 9714 9715 +6894 48 9714 9716 +6895 48 9717 9718 +6896 48 9717 9719 +6897 48 9720 9721 +6898 48 9720 9722 +6899 48 9723 9724 +6900 48 9723 9725 +6901 48 9726 9727 +6902 48 9726 9728 +6903 48 9729 9730 +6904 48 9729 9731 +6905 48 9732 9733 +6906 48 9732 9734 +6907 48 9735 9736 +6908 48 9735 9737 +6909 49 1234 1235 +6910 49 1237 1238 +6911 49 1240 1241 +6912 49 1243 1244 +6913 49 1246 1247 +6914 49 1249 1250 +6915 49 1252 1253 +6916 49 1255 1256 +6917 49 1258 1259 +6918 49 1261 1262 +6919 49 1264 1265 +6920 49 1267 1268 +6921 49 1270 1271 +6922 49 1273 1274 +6923 49 1276 1277 +6924 49 1279 1280 +6925 49 1282 1283 +6926 49 1285 1286 +6927 49 1288 1289 +6928 49 1291 1292 +6929 49 1294 1295 +6930 49 1297 1298 +6931 49 1300 1301 +6932 49 1303 1304 +6933 49 1306 1307 +6934 49 1309 1310 +6935 49 1312 1313 +6936 49 1315 1316 +6937 49 1318 1319 +6938 49 1321 1322 +6939 49 1324 1325 +6940 49 1327 1328 +6941 49 1330 1331 +6942 49 1333 1334 +6943 49 1336 1337 +6944 49 1339 1340 +6945 49 1342 1343 +6946 49 1345 1346 +6947 49 1348 1349 +6948 49 1351 1352 +6949 49 1354 1355 +6950 49 1357 1358 +6951 49 1360 1361 +6952 49 1363 1364 +6953 49 1366 1367 +6954 49 1369 1370 +6955 49 1372 1373 +6956 49 1375 1376 +6957 49 1378 1379 +6958 49 1381 1382 +6959 49 1384 1385 +6960 49 1387 1388 +6961 49 1390 1391 +6962 49 1393 1394 +6963 49 1396 1397 +6964 49 1399 1400 +6965 49 1402 1403 +6966 49 1405 1406 +6967 49 1408 1409 +6968 49 1411 1412 +6969 49 1414 1415 +6970 49 1417 1418 +6971 49 1420 1421 +6972 49 1423 1424 +6973 49 1426 1427 +6974 49 1429 1430 +6975 49 1432 1433 +6976 49 1435 1436 +6977 49 1438 1439 +6978 49 1441 1442 +6979 49 1444 1445 +6980 49 1447 1448 +6981 49 1450 1451 +6982 49 1453 1454 +6983 49 1456 1457 +6984 49 1459 1460 +6985 49 1462 1463 +6986 49 1465 1466 +6987 49 1468 1469 +6988 49 1471 1472 +6989 49 1474 1475 +6990 49 1477 1478 +6991 49 1480 1481 +6992 49 1483 1484 +6993 49 1486 1487 +6994 49 1489 1490 +6995 49 1492 1493 +6996 49 1495 1496 +6997 49 1498 1499 +6998 49 1501 1502 +6999 49 1504 1505 +7000 49 1507 1508 +7001 49 1510 1511 +7002 49 1513 1514 +7003 49 1516 1517 +7004 49 1519 1520 +7005 49 1522 1523 +7006 49 1525 1526 +7007 49 1528 1529 +7008 49 1531 1532 +7009 49 1534 1535 +7010 49 1537 1538 +7011 49 1540 1541 +7012 49 1543 1544 +7013 49 1546 1547 +7014 49 1549 1550 +7015 49 1552 1553 +7016 49 1555 1556 +7017 49 1558 1559 +7018 49 1561 1562 +7019 49 1564 1565 +7020 49 1567 1568 +7021 49 1570 1571 +7022 49 1573 1574 +7023 49 1576 1577 +7024 49 1579 1580 +7025 49 1582 1583 +7026 49 1585 1586 +7027 49 1588 1589 +7028 49 1591 1592 +7029 49 1594 1595 +7030 49 1597 1598 +7031 49 1600 1601 +7032 49 1603 1604 +7033 49 1606 1607 +7034 49 1609 1610 +7035 49 1612 1613 +7036 49 1615 1616 +7037 49 1618 1619 +7038 49 1621 1622 +7039 49 1624 1625 +7040 49 1627 1628 +7041 49 1630 1631 +7042 49 1633 1634 +7043 49 1636 1637 +7044 49 1639 1640 +7045 49 1642 1643 +7046 49 1645 1646 +7047 49 1648 1649 +7048 49 1651 1652 +7049 49 1654 1655 +7050 49 1657 1658 +7051 49 1660 1661 +7052 49 1663 1664 +7053 49 1666 1667 +7054 49 1669 1670 +7055 49 1672 1673 +7056 49 1675 1676 +7057 49 1678 1679 +7058 49 1681 1682 +7059 49 1684 1685 +7060 49 1687 1688 +7061 49 1690 1691 +7062 49 1693 1694 +7063 49 1696 1697 +7064 49 1699 1700 +7065 49 1702 1703 +7066 49 1705 1706 +7067 49 1708 1709 +7068 49 1711 1712 +7069 49 1714 1715 +7070 49 1717 1718 +7071 49 1720 1721 +7072 49 1723 1724 +7073 49 1726 1727 +7074 49 1729 1730 +7075 49 1732 1733 +7076 49 1735 1736 +7077 49 1738 1739 +7078 49 1741 1742 +7079 49 1744 1745 +7080 49 1747 1748 +7081 49 1750 1751 +7082 49 1753 1754 +7083 49 1756 1757 +7084 49 1759 1760 +7085 49 1762 1763 +7086 49 1765 1766 +7087 49 1768 1769 +7088 49 1771 1772 +7089 49 1774 1775 +7090 49 1777 1778 +7091 49 1780 1781 +7092 49 1783 1784 +7093 49 1786 1787 +7094 49 1789 1790 +7095 49 1792 1793 +7096 49 1795 1796 +7097 49 1798 1799 +7098 49 1801 1802 +7099 49 1804 1805 +7100 49 1807 1808 +7101 49 1810 1811 +7102 49 1813 1814 +7103 49 1816 1817 +7104 49 1819 1820 +7105 49 1822 1823 +7106 49 1825 1826 +7107 49 1828 1829 +7108 49 1831 1832 +7109 49 1834 1835 +7110 49 1837 1838 +7111 49 1840 1841 +7112 49 1843 1844 +7113 49 1846 1847 +7114 49 1849 1850 +7115 49 1852 1853 +7116 49 1855 1856 +7117 49 1858 1859 +7118 49 1861 1862 +7119 49 1864 1865 +7120 49 1867 1868 +7121 49 1870 1871 +7122 49 1873 1874 +7123 49 1876 1877 +7124 49 1879 1880 +7125 49 1882 1883 +7126 49 1885 1886 +7127 49 1888 1889 +7128 49 1891 1892 +7129 49 1894 1895 +7130 49 1897 1898 +7131 49 1900 1901 +7132 49 1903 1904 +7133 49 1906 1907 +7134 49 1909 1910 +7135 49 1912 1913 +7136 49 1915 1916 +7137 49 1918 1919 +7138 49 1921 1922 +7139 49 1924 1925 +7140 49 1927 1928 +7141 49 1930 1931 +7142 49 1933 1934 +7143 49 1936 1937 +7144 49 1939 1940 +7145 49 1942 1943 +7146 49 1945 1946 +7147 49 1948 1949 +7148 49 1951 1952 +7149 49 1954 1955 +7150 49 1957 1958 +7151 49 1960 1961 +7152 49 1963 1964 +7153 49 1966 1967 +7154 49 1969 1970 +7155 49 1972 1973 +7156 49 1975 1976 +7157 49 1978 1979 +7158 49 1981 1982 +7159 49 1984 1985 +7160 49 1987 1988 +7161 49 1990 1991 +7162 49 1993 1994 +7163 49 1996 1997 +7164 49 1999 2000 +7165 49 2002 2003 +7166 49 2005 2006 +7167 49 2008 2009 +7168 49 2011 2012 +7169 49 2014 2015 +7170 49 2017 2018 +7171 49 2020 2021 +7172 49 2023 2024 +7173 49 2026 2027 +7174 49 2029 2030 +7175 49 2032 2033 +7176 49 2035 2036 +7177 49 2038 2039 +7178 49 2041 2042 +7179 49 2044 2045 +7180 49 2047 2048 +7181 49 2050 2051 +7182 49 2053 2054 +7183 49 2056 2057 +7184 49 2059 2060 +7185 49 2062 2063 +7186 49 2065 2066 +7187 49 2068 2069 +7188 49 2071 2072 +7189 49 2074 2075 +7190 49 2077 2078 +7191 49 2080 2081 +7192 49 2083 2084 +7193 49 2086 2087 +7194 49 2089 2090 +7195 49 2092 2093 +7196 49 2095 2096 +7197 49 2098 2099 +7198 49 2101 2102 +7199 49 2104 2105 +7200 49 2107 2108 +7201 49 2110 2111 +7202 49 2113 2114 +7203 49 2116 2117 +7204 49 2119 2120 +7205 49 2122 2123 +7206 49 2125 2126 +7207 49 2128 2129 +7208 49 2131 2132 +7209 49 2134 2135 +7210 49 2137 2138 +7211 49 2140 2141 +7212 49 2143 2144 +7213 49 2146 2147 +7214 49 2149 2150 +7215 49 2152 2153 +7216 49 2155 2156 +7217 49 2158 2159 +7218 49 2161 2162 +7219 49 2164 2165 +7220 49 2167 2168 +7221 49 2170 2171 +7222 49 2173 2174 +7223 49 2176 2177 +7224 49 2179 2180 +7225 49 2182 2183 +7226 49 2185 2186 +7227 49 2188 2189 +7228 49 2191 2192 +7229 49 2194 2195 +7230 49 2197 2198 +7231 49 2200 2201 +7232 49 2203 2204 +7233 49 2206 2207 +7234 49 2209 2210 +7235 49 2212 2213 +7236 49 2215 2216 +7237 49 2218 2219 +7238 49 2221 2222 +7239 49 2224 2225 +7240 49 2227 2228 +7241 49 2230 2231 +7242 49 2233 2234 +7243 49 2236 2237 +7244 49 2239 2240 +7245 49 2242 2243 +7246 49 2245 2246 +7247 49 2248 2249 +7248 49 2251 2252 +7249 49 2254 2255 +7250 49 2257 2258 +7251 49 2260 2261 +7252 49 2263 2264 +7253 49 2266 2267 +7254 49 2269 2270 +7255 49 2272 2273 +7256 49 2275 2276 +7257 49 2278 2279 +7258 49 2281 2282 +7259 49 2284 2285 +7260 49 2287 2288 +7261 49 2290 2291 +7262 49 2293 2294 +7263 49 2296 2297 +7264 49 2299 2300 +7265 49 2302 2303 +7266 49 2305 2306 +7267 49 2308 2309 +7268 49 2311 2312 +7269 49 2314 2315 +7270 49 2317 2318 +7271 49 2320 2321 +7272 49 2323 2324 +7273 49 2326 2327 +7274 49 2329 2330 +7275 49 2332 2333 +7276 49 2335 2336 +7277 49 2338 2339 +7278 49 2341 2342 +7279 49 2344 2345 +7280 49 2347 2348 +7281 49 2350 2351 +7282 49 2353 2354 +7283 49 2356 2357 +7284 49 2359 2360 +7285 49 2362 2363 +7286 49 2365 2366 +7287 49 2368 2369 +7288 49 2371 2372 +7289 49 2374 2375 +7290 49 2377 2378 +7291 49 2380 2381 +7292 49 2383 2384 +7293 49 2386 2387 +7294 49 2389 2390 +7295 49 2392 2393 +7296 49 2395 2396 +7297 49 2398 2399 +7298 49 2401 2402 +7299 49 2404 2405 +7300 49 2407 2408 +7301 49 2410 2411 +7302 49 2413 2414 +7303 49 2416 2417 +7304 49 2419 2420 +7305 49 2422 2423 +7306 49 2425 2426 +7307 49 2428 2429 +7308 49 2431 2432 +7309 49 2434 2435 +7310 49 2437 2438 +7311 49 2440 2441 +7312 49 2443 2444 +7313 49 2446 2447 +7314 49 2449 2450 +7315 49 2452 2453 +7316 49 2455 2456 +7317 49 2458 2459 +7318 49 2461 2462 +7319 49 2464 2465 +7320 49 2467 2468 +7321 49 2470 2471 +7322 49 2473 2474 +7323 49 2476 2477 +7324 49 2479 2480 +7325 49 2482 2483 +7326 49 2485 2486 +7327 49 2488 2489 +7328 49 2491 2492 +7329 49 2494 2495 +7330 49 2497 2498 +7331 49 2500 2501 +7332 49 2503 2504 +7333 49 2506 2507 +7334 49 2509 2510 +7335 49 2512 2513 +7336 49 2515 2516 +7337 49 2518 2519 +7338 49 2521 2522 +7339 49 2524 2525 +7340 49 2527 2528 +7341 49 2530 2531 +7342 49 2533 2534 +7343 49 2536 2537 +7344 49 2539 2540 +7345 49 2542 2543 +7346 49 2545 2546 +7347 49 2548 2549 +7348 49 2551 2552 +7349 49 2554 2555 +7350 49 2557 2558 +7351 49 2560 2561 +7352 49 2563 2564 +7353 49 2566 2567 +7354 49 2569 2570 +7355 49 2572 2573 +7356 49 2575 2576 +7357 49 2578 2579 +7358 49 2581 2582 +7359 49 2584 2585 +7360 49 2587 2588 +7361 49 2590 2591 +7362 49 2593 2594 +7363 49 2596 2597 +7364 49 2599 2600 +7365 49 2602 2603 +7366 49 2605 2606 +7367 49 2608 2609 +7368 49 2611 2612 +7369 49 2614 2615 +7370 49 2617 2618 +7371 49 2620 2621 +7372 49 2623 2624 +7373 49 2626 2627 +7374 49 2629 2630 +7375 49 2632 2633 +7376 49 2635 2636 +7377 49 2638 2639 +7378 49 2641 2642 +7379 49 2644 2645 +7380 49 2647 2648 +7381 49 2650 2651 +7382 49 2653 2654 +7383 49 2656 2657 +7384 49 2659 2660 +7385 49 2662 2663 +7386 49 2665 2666 +7387 49 2668 2669 +7388 49 2671 2672 +7389 49 2674 2675 +7390 49 2677 2678 +7391 49 2680 2681 +7392 49 2683 2684 +7393 49 2686 2687 +7394 49 2689 2690 +7395 49 2692 2693 +7396 49 2695 2696 +7397 49 2698 2699 +7398 49 2701 2702 +7399 49 2704 2705 +7400 49 2707 2708 +7401 49 2710 2711 +7402 49 2713 2714 +7403 49 2716 2717 +7404 49 2719 2720 +7405 49 2722 2723 +7406 49 2725 2726 +7407 49 2728 2729 +7408 49 2731 2732 +7409 49 2734 2735 +7410 49 2737 2738 +7411 49 2740 2741 +7412 49 2743 2744 +7413 49 2746 2747 +7414 49 2749 2750 +7415 49 2752 2753 +7416 49 2755 2756 +7417 49 2758 2759 +7418 49 2761 2762 +7419 49 2764 2765 +7420 49 2767 2768 +7421 49 2770 2771 +7422 49 2773 2774 +7423 49 2776 2777 +7424 49 2779 2780 +7425 49 2782 2783 +7426 49 2785 2786 +7427 49 2788 2789 +7428 49 2791 2792 +7429 49 2794 2795 +7430 49 2797 2798 +7431 49 2800 2801 +7432 49 2803 2804 +7433 49 2806 2807 +7434 49 2809 2810 +7435 49 2812 2813 +7436 49 2815 2816 +7437 49 2818 2819 +7438 49 2821 2822 +7439 49 2824 2825 +7440 49 2827 2828 +7441 49 2830 2831 +7442 49 2833 2834 +7443 49 2836 2837 +7444 49 2839 2840 +7445 49 2842 2843 +7446 49 2845 2846 +7447 49 2848 2849 +7448 49 2851 2852 +7449 49 2854 2855 +7450 49 2857 2858 +7451 49 2860 2861 +7452 49 2863 2864 +7453 49 2866 2867 +7454 49 2869 2870 +7455 49 2872 2873 +7456 49 2875 2876 +7457 49 2878 2879 +7458 49 2881 2882 +7459 49 2884 2885 +7460 49 2887 2888 +7461 49 2890 2891 +7462 49 2893 2894 +7463 49 2896 2897 +7464 49 2899 2900 +7465 49 2902 2903 +7466 49 2905 2906 +7467 49 2908 2909 +7468 49 2911 2912 +7469 49 2914 2915 +7470 49 2917 2918 +7471 49 2920 2921 +7472 49 2923 2924 +7473 49 2926 2927 +7474 49 2929 2930 +7475 49 2932 2933 +7476 49 2935 2936 +7477 49 2938 2939 +7478 49 2941 2942 +7479 49 2944 2945 +7480 49 2947 2948 +7481 49 2950 2951 +7482 49 2953 2954 +7483 49 2956 2957 +7484 49 2959 2960 +7485 49 2962 2963 +7486 49 2965 2966 +7487 49 2968 2969 +7488 49 2971 2972 +7489 49 2974 2975 +7490 49 2977 2978 +7491 49 2980 2981 +7492 49 2983 2984 +7493 49 2986 2987 +7494 49 2989 2990 +7495 49 2992 2993 +7496 49 2995 2996 +7497 49 2998 2999 +7498 49 3001 3002 +7499 49 3004 3005 +7500 49 3007 3008 +7501 49 3010 3011 +7502 49 3013 3014 +7503 49 3016 3017 +7504 49 3019 3020 +7505 49 3022 3023 +7506 49 3025 3026 +7507 49 3028 3029 +7508 49 3031 3032 +7509 49 3034 3035 +7510 49 3037 3038 +7511 49 3040 3041 +7512 49 3043 3044 +7513 49 3046 3047 +7514 49 3049 3050 +7515 49 3052 3053 +7516 49 3055 3056 +7517 49 3058 3059 +7518 49 3061 3062 +7519 49 3064 3065 +7520 49 3067 3068 +7521 49 3070 3071 +7522 49 3073 3074 +7523 49 3076 3077 +7524 49 3079 3080 +7525 49 3082 3083 +7526 49 3085 3086 +7527 49 3088 3089 +7528 49 3091 3092 +7529 49 3094 3095 +7530 49 3097 3098 +7531 49 3100 3101 +7532 49 3103 3104 +7533 49 3106 3107 +7534 49 3109 3110 +7535 49 3112 3113 +7536 49 3115 3116 +7537 49 3118 3119 +7538 49 3121 3122 +7539 49 3124 3125 +7540 49 3127 3128 +7541 49 3130 3131 +7542 49 3133 3134 +7543 49 3136 3137 +7544 49 3139 3140 +7545 49 3142 3143 +7546 49 3145 3146 +7547 49 3148 3149 +7548 49 3151 3152 +7549 49 3154 3155 +7550 49 3157 3158 +7551 49 3160 3161 +7552 49 3163 3164 +7553 49 3166 3167 +7554 49 3169 3170 +7555 49 3172 3173 +7556 49 3175 3176 +7557 49 3178 3179 +7558 49 3181 3182 +7559 49 3184 3185 +7560 49 3187 3188 +7561 49 3190 3191 +7562 49 3193 3194 +7563 49 3196 3197 +7564 49 3199 3200 +7565 49 3202 3203 +7566 49 3205 3206 +7567 49 3208 3209 +7568 49 3211 3212 +7569 49 3214 3215 +7570 49 3217 3218 +7571 49 3220 3221 +7572 49 3223 3224 +7573 49 3226 3227 +7574 49 3229 3230 +7575 49 3232 3233 +7576 49 3235 3236 +7577 49 3238 3239 +7578 49 3241 3242 +7579 49 3244 3245 +7580 49 3247 3248 +7581 49 3250 3251 +7582 49 3253 3254 +7583 49 3256 3257 +7584 49 3259 3260 +7585 49 3262 3263 +7586 49 3265 3266 +7587 49 3268 3269 +7588 49 3271 3272 +7589 49 3274 3275 +7590 49 3277 3278 +7591 49 3280 3281 +7592 49 3283 3284 +7593 49 3286 3287 +7594 49 3289 3290 +7595 49 3292 3293 +7596 49 3295 3296 +7597 49 3298 3299 +7598 49 3301 3302 +7599 49 3304 3305 +7600 49 3307 3308 +7601 49 3310 3311 +7602 49 3313 3314 +7603 49 3316 3317 +7604 49 3319 3320 +7605 49 3322 3323 +7606 49 3325 3326 +7607 49 3328 3329 +7608 49 3331 3332 +7609 49 3334 3335 +7610 49 3337 3338 +7611 49 3340 3341 +7612 49 3343 3344 +7613 49 3346 3347 +7614 49 3349 3350 +7615 49 3352 3353 +7616 49 3355 3356 +7617 49 3358 3359 +7618 49 3361 3362 +7619 49 3364 3365 +7620 49 3367 3368 +7621 49 3370 3371 +7622 49 3373 3374 +7623 49 3376 3377 +7624 49 3379 3380 +7625 49 3382 3383 +7626 49 3385 3386 +7627 49 3388 3389 +7628 49 3391 3392 +7629 49 3394 3395 +7630 49 3397 3398 +7631 49 3400 3401 +7632 49 3403 3404 +7633 49 3406 3407 +7634 49 3409 3410 +7635 49 3412 3413 +7636 49 3415 3416 +7637 49 3418 3419 +7638 49 3421 3422 +7639 49 3424 3425 +7640 49 3427 3428 +7641 49 3430 3431 +7642 49 3433 3434 +7643 49 3436 3437 +7644 49 3439 3440 +7645 49 3442 3443 +7646 49 3445 3446 +7647 49 3448 3449 +7648 49 3451 3452 +7649 49 3454 3455 +7650 49 3457 3458 +7651 49 3460 3461 +7652 49 3463 3464 +7653 49 3466 3467 +7654 49 3469 3470 +7655 49 3472 3473 +7656 49 3475 3476 +7657 49 3478 3479 +7658 49 3481 3482 +7659 49 3484 3485 +7660 49 3487 3488 +7661 49 3490 3491 +7662 49 3493 3494 +7663 49 3496 3497 +7664 49 3499 3500 +7665 49 3502 3503 +7666 49 3505 3506 +7667 49 3508 3509 +7668 49 3511 3512 +7669 49 3514 3515 +7670 49 3517 3518 +7671 49 3520 3521 +7672 49 3523 3524 +7673 49 3526 3527 +7674 49 3529 3530 +7675 49 3532 3533 +7676 49 3535 3536 +7677 49 3538 3539 +7678 49 3541 3542 +7679 49 3544 3545 +7680 49 3547 3548 +7681 49 3550 3551 +7682 49 3553 3554 +7683 49 3556 3557 +7684 49 3559 3560 +7685 49 3562 3563 +7686 49 3565 3566 +7687 49 3568 3569 +7688 49 3571 3572 +7689 49 3574 3575 +7690 49 3577 3578 +7691 49 3580 3581 +7692 49 3583 3584 +7693 49 3586 3587 +7694 49 3589 3590 +7695 49 3592 3593 +7696 49 3595 3596 +7697 49 3598 3599 +7698 49 3601 3602 +7699 49 3604 3605 +7700 49 3607 3608 +7701 49 3610 3611 +7702 49 3613 3614 +7703 49 3616 3617 +7704 49 3619 3620 +7705 49 3622 3623 +7706 49 3625 3626 +7707 49 3628 3629 +7708 49 3631 3632 +7709 49 3634 3635 +7710 49 3637 3638 +7711 49 3640 3641 +7712 49 3643 3644 +7713 49 3646 3647 +7714 49 3649 3650 +7715 49 3652 3653 +7716 49 3655 3656 +7717 49 3658 3659 +7718 49 3661 3662 +7719 49 3664 3665 +7720 49 3667 3668 +7721 49 3670 3671 +7722 49 3673 3674 +7723 49 3676 3677 +7724 49 3679 3680 +7725 49 3682 3683 +7726 49 3685 3686 +7727 49 3688 3689 +7728 49 3691 3692 +7729 49 3694 3695 +7730 49 3697 3698 +7731 49 3700 3701 +7732 49 3703 3704 +7733 49 3706 3707 +7734 49 3709 3710 +7735 49 3712 3713 +7736 49 3715 3716 +7737 49 3718 3719 +7738 49 3721 3722 +7739 49 3724 3725 +7740 49 3727 3728 +7741 49 3730 3731 +7742 49 3733 3734 +7743 49 3736 3737 +7744 49 3739 3740 +7745 49 3742 3743 +7746 49 3745 3746 +7747 49 3748 3749 +7748 49 3751 3752 +7749 49 3754 3755 +7750 49 3757 3758 +7751 49 3760 3761 +7752 49 3763 3764 +7753 49 3766 3767 +7754 49 3769 3770 +7755 49 3772 3773 +7756 49 3775 3776 +7757 49 3778 3779 +7758 49 3781 3782 +7759 49 3784 3785 +7760 49 3787 3788 +7761 49 3790 3791 +7762 49 3793 3794 +7763 49 3796 3797 +7764 49 3799 3800 +7765 49 3802 3803 +7766 49 3805 3806 +7767 49 3808 3809 +7768 49 3811 3812 +7769 49 3814 3815 +7770 49 3817 3818 +7771 49 3820 3821 +7772 49 3823 3824 +7773 49 3826 3827 +7774 49 3829 3830 +7775 49 3832 3833 +7776 49 3835 3836 +7777 49 3838 3839 +7778 49 3841 3842 +7779 49 3844 3845 +7780 49 3847 3848 +7781 49 3850 3851 +7782 49 3853 3854 +7783 49 3856 3857 +7784 49 3859 3860 +7785 49 3862 3863 +7786 49 3865 3866 +7787 49 3868 3869 +7788 49 3871 3872 +7789 49 3874 3875 +7790 49 3877 3878 +7791 49 3880 3881 +7792 49 3883 3884 +7793 49 3886 3887 +7794 49 3889 3890 +7795 49 3892 3893 +7796 49 3895 3896 +7797 49 3898 3899 +7798 49 3901 3902 +7799 49 3904 3905 +7800 49 3907 3908 +7801 49 3910 3911 +7802 49 3913 3914 +7803 49 3916 3917 +7804 49 3919 3920 +7805 49 3922 3923 +7806 49 3925 3926 +7807 49 3928 3929 +7808 49 3931 3932 +7809 49 3934 3935 +7810 49 3937 3938 +7811 49 3940 3941 +7812 49 3943 3944 +7813 49 3946 3947 +7814 49 3949 3950 +7815 49 3952 3953 +7816 49 3955 3956 +7817 49 3958 3959 +7818 49 3961 3962 +7819 49 3964 3965 +7820 49 3967 3968 +7821 49 3970 3971 +7822 49 3973 3974 +7823 49 3976 3977 +7824 49 3979 3980 +7825 49 3982 3983 +7826 49 3985 3986 +7827 49 3988 3989 +7828 49 3991 3992 +7829 49 3994 3995 +7830 49 3997 3998 +7831 49 4000 4001 +7832 49 4003 4004 +7833 49 4006 4007 +7834 49 4009 4010 +7835 49 4012 4013 +7836 49 4015 4016 +7837 49 4018 4019 +7838 49 4021 4022 +7839 49 4024 4025 +7840 49 4027 4028 +7841 49 4030 4031 +7842 49 4033 4034 +7843 49 4036 4037 +7844 49 4039 4040 +7845 49 4042 4043 +7846 49 4045 4046 +7847 49 4048 4049 +7848 49 4051 4052 +7849 49 4054 4055 +7850 49 4057 4058 +7851 49 4060 4061 +7852 49 4063 4064 +7853 49 4066 4067 +7854 49 4069 4070 +7855 49 4072 4073 +7856 49 4075 4076 +7857 49 4078 4079 +7858 49 4081 4082 +7859 49 4084 4085 +7860 49 4087 4088 +7861 49 4090 4091 +7862 49 4093 4094 +7863 49 4096 4097 +7864 49 4099 4100 +7865 49 4102 4103 +7866 49 4105 4106 +7867 49 4108 4109 +7868 49 4111 4112 +7869 49 4114 4115 +7870 49 4117 4118 +7871 49 4120 4121 +7872 49 4123 4124 +7873 49 4126 4127 +7874 49 4129 4130 +7875 49 4132 4133 +7876 49 4135 4136 +7877 49 4138 4139 +7878 49 4141 4142 +7879 49 4144 4145 +7880 49 4147 4148 +7881 49 4150 4151 +7882 49 4153 4154 +7883 49 4156 4157 +7884 49 4159 4160 +7885 49 4162 4163 +7886 49 4165 4166 +7887 49 4168 4169 +7888 49 4171 4172 +7889 49 4174 4175 +7890 49 4177 4178 +7891 49 4180 4181 +7892 49 4183 4184 +7893 49 4186 4187 +7894 49 4189 4190 +7895 49 4192 4193 +7896 49 4195 4196 +7897 49 4198 4199 +7898 49 4201 4202 +7899 49 4204 4205 +7900 49 4207 4208 +7901 49 4210 4211 +7902 49 4213 4214 +7903 49 4216 4217 +7904 49 4219 4220 +7905 49 4222 4223 +7906 49 4225 4226 +7907 49 4228 4229 +7908 49 4231 4232 +7909 49 4234 4235 +7910 49 4237 4238 +7911 49 4240 4241 +7912 49 4243 4244 +7913 49 4246 4247 +7914 49 4249 4250 +7915 49 4252 4253 +7916 49 4255 4256 +7917 49 4258 4259 +7918 49 4261 4262 +7919 49 4264 4265 +7920 49 4267 4268 +7921 49 4270 4271 +7922 49 4273 4274 +7923 49 4276 4277 +7924 49 4279 4280 +7925 49 4282 4283 +7926 49 4285 4286 +7927 49 4288 4289 +7928 49 4291 4292 +7929 49 4294 4295 +7930 49 4297 4298 +7931 49 4300 4301 +7932 49 4303 4304 +7933 49 4306 4307 +7934 49 4309 4310 +7935 49 4312 4313 +7936 49 4315 4316 +7937 49 4318 4319 +7938 49 4321 4322 +7939 49 4324 4325 +7940 49 4327 4328 +7941 49 4330 4331 +7942 49 4333 4334 +7943 49 4336 4337 +7944 49 4339 4340 +7945 49 4342 4343 +7946 49 4345 4346 +7947 49 4348 4349 +7948 49 4351 4352 +7949 49 4354 4355 +7950 49 4357 4358 +7951 49 4360 4361 +7952 49 4363 4364 +7953 49 4366 4367 +7954 49 4369 4370 +7955 49 4372 4373 +7956 49 4375 4376 +7957 49 4378 4379 +7958 49 4381 4382 +7959 49 4384 4385 +7960 49 4387 4388 +7961 49 4390 4391 +7962 49 4393 4394 +7963 49 4396 4397 +7964 49 4399 4400 +7965 49 4402 4403 +7966 49 4405 4406 +7967 49 4408 4409 +7968 49 4411 4412 +7969 49 4414 4415 +7970 49 4417 4418 +7971 49 4420 4421 +7972 49 4423 4424 +7973 49 4426 4427 +7974 49 4429 4430 +7975 49 4432 4433 +7976 49 4435 4436 +7977 49 4438 4439 +7978 49 4441 4442 +7979 49 4444 4445 +7980 49 4447 4448 +7981 49 4450 4451 +7982 49 4453 4454 +7983 49 4456 4457 +7984 49 4459 4460 +7985 49 4462 4463 +7986 49 4465 4466 +7987 49 4468 4469 +7988 49 4471 4472 +7989 49 4474 4475 +7990 49 4477 4478 +7991 49 4480 4481 +7992 49 4483 4484 +7993 49 4486 4487 +7994 49 4489 4490 +7995 49 4492 4493 +7996 49 4495 4496 +7997 49 4498 4499 +7998 49 4501 4502 +7999 49 4504 4505 +8000 49 4507 4508 +8001 49 4510 4511 +8002 49 4513 4514 +8003 49 4516 4517 +8004 49 4519 4520 +8005 49 4522 4523 +8006 49 4525 4526 +8007 49 4528 4529 +8008 49 4531 4532 +8009 49 4534 4535 +8010 49 4537 4538 +8011 49 4540 4541 +8012 49 4543 4544 +8013 49 4546 4547 +8014 49 4549 4550 +8015 49 4552 4553 +8016 49 4555 4556 +8017 49 4558 4559 +8018 49 4561 4562 +8019 49 4564 4565 +8020 49 4567 4568 +8021 49 4570 4571 +8022 49 4573 4574 +8023 49 4576 4577 +8024 49 4579 4580 +8025 49 4582 4583 +8026 49 4585 4586 +8027 49 4588 4589 +8028 49 4591 4592 +8029 49 4594 4595 +8030 49 4597 4598 +8031 49 4600 4601 +8032 49 4603 4604 +8033 49 4606 4607 +8034 49 4609 4610 +8035 49 4612 4613 +8036 49 4615 4616 +8037 49 4618 4619 +8038 49 4621 4622 +8039 49 4624 4625 +8040 49 4627 4628 +8041 49 4630 4631 +8042 49 4633 4634 +8043 49 4636 4637 +8044 49 4639 4640 +8045 49 4642 4643 +8046 49 4645 4646 +8047 49 4648 4649 +8048 49 4651 4652 +8049 49 4654 4655 +8050 49 4657 4658 +8051 49 4660 4661 +8052 49 4663 4664 +8053 49 4666 4667 +8054 49 4669 4670 +8055 49 4672 4673 +8056 49 4675 4676 +8057 49 4678 4679 +8058 49 4681 4682 +8059 49 4684 4685 +8060 49 4687 4688 +8061 49 4690 4691 +8062 49 4693 4694 +8063 49 4696 4697 +8064 49 4699 4700 +8065 49 4702 4703 +8066 49 4705 4706 +8067 49 4708 4709 +8068 49 4711 4712 +8069 49 4714 4715 +8070 49 4717 4718 +8071 49 4720 4721 +8072 49 4723 4724 +8073 49 4726 4727 +8074 49 4729 4730 +8075 49 4732 4733 +8076 49 4735 4736 +8077 49 4738 4739 +8078 49 4741 4742 +8079 49 4744 4745 +8080 49 4747 4748 +8081 49 4750 4751 +8082 49 4753 4754 +8083 49 4756 4757 +8084 49 4759 4760 +8085 49 4762 4763 +8086 49 4765 4766 +8087 49 4768 4769 +8088 49 4771 4772 +8089 49 4774 4775 +8090 49 4777 4778 +8091 49 4780 4781 +8092 49 4783 4784 +8093 49 4786 4787 +8094 49 4789 4790 +8095 49 4792 4793 +8096 49 4795 4796 +8097 49 4798 4799 +8098 49 4801 4802 +8099 49 4804 4805 +8100 49 4807 4808 +8101 49 4810 4811 +8102 49 4813 4814 +8103 49 4816 4817 +8104 49 4819 4820 +8105 49 4822 4823 +8106 49 4825 4826 +8107 49 4828 4829 +8108 49 4831 4832 +8109 49 4834 4835 +8110 49 4837 4838 +8111 49 4840 4841 +8112 49 4843 4844 +8113 49 4846 4847 +8114 49 4849 4850 +8115 49 4852 4853 +8116 49 4855 4856 +8117 49 4858 4859 +8118 49 4861 4862 +8119 49 4864 4865 +8120 49 4867 4868 +8121 49 4870 4871 +8122 49 4873 4874 +8123 49 4876 4877 +8124 49 4879 4880 +8125 49 4882 4883 +8126 49 4885 4886 +8127 49 4888 4889 +8128 49 4891 4892 +8129 49 4894 4895 +8130 49 4897 4898 +8131 49 4900 4901 +8132 49 4903 4904 +8133 49 4906 4907 +8134 49 4909 4910 +8135 49 4912 4913 +8136 49 4915 4916 +8137 49 4918 4919 +8138 49 4921 4922 +8139 49 4924 4925 +8140 49 4927 4928 +8141 49 4930 4931 +8142 49 4933 4934 +8143 49 4936 4937 +8144 49 4939 4940 +8145 49 4942 4943 +8146 49 4945 4946 +8147 49 4948 4949 +8148 49 4951 4952 +8149 49 4954 4955 +8150 49 4957 4958 +8151 49 4960 4961 +8152 49 4963 4964 +8153 49 4966 4967 +8154 49 4969 4970 +8155 49 4972 4973 +8156 49 4975 4976 +8157 49 4978 4979 +8158 49 4981 4982 +8159 49 4984 4985 +8160 49 4987 4988 +8161 49 4990 4991 +8162 49 4993 4994 +8163 49 4996 4997 +8164 49 4999 5000 +8165 49 5002 5003 +8166 49 5005 5006 +8167 49 5008 5009 +8168 49 5011 5012 +8169 49 5014 5015 +8170 49 5017 5018 +8171 49 5020 5021 +8172 49 5023 5024 +8173 49 5026 5027 +8174 49 5029 5030 +8175 49 5032 5033 +8176 49 5035 5036 +8177 49 5038 5039 +8178 49 5041 5042 +8179 49 5044 5045 +8180 49 5047 5048 +8181 49 5050 5051 +8182 49 5053 5054 +8183 49 5056 5057 +8184 49 5059 5060 +8185 49 5062 5063 +8186 49 5065 5066 +8187 49 5068 5069 +8188 49 5071 5072 +8189 49 5074 5075 +8190 49 5077 5078 +8191 49 5080 5081 +8192 49 5083 5084 +8193 49 5086 5087 +8194 49 5089 5090 +8195 49 5092 5093 +8196 49 5095 5096 +8197 49 5098 5099 +8198 49 5101 5102 +8199 49 5104 5105 +8200 49 5107 5108 +8201 49 5110 5111 +8202 49 5113 5114 +8203 49 5116 5117 +8204 49 5119 5120 +8205 49 5122 5123 +8206 49 5125 5126 +8207 49 5128 5129 +8208 49 5131 5132 +8209 49 5134 5135 +8210 49 5137 5138 +8211 49 5140 5141 +8212 49 5143 5144 +8213 49 5146 5147 +8214 49 5149 5150 +8215 49 5152 5153 +8216 49 5155 5156 +8217 49 5158 5159 +8218 49 5161 5162 +8219 49 5164 5165 +8220 49 5167 5168 +8221 49 5170 5171 +8222 49 5173 5174 +8223 49 5176 5177 +8224 49 5179 5180 +8225 49 5182 5183 +8226 49 5185 5186 +8227 49 5188 5189 +8228 49 5191 5192 +8229 49 5194 5195 +8230 49 5197 5198 +8231 49 5200 5201 +8232 49 5203 5204 +8233 49 5206 5207 +8234 49 5209 5210 +8235 49 5212 5213 +8236 49 5215 5216 +8237 49 5218 5219 +8238 49 5221 5222 +8239 49 5224 5225 +8240 49 5227 5228 +8241 49 5230 5231 +8242 49 5233 5234 +8243 49 5236 5237 +8244 49 5239 5240 +8245 49 5242 5243 +8246 49 5245 5246 +8247 49 5248 5249 +8248 49 5251 5252 +8249 49 5254 5255 +8250 49 5257 5258 +8251 49 5260 5261 +8252 49 5263 5264 +8253 49 5266 5267 +8254 49 5269 5270 +8255 49 5272 5273 +8256 49 5275 5276 +8257 49 5278 5279 +8258 49 5281 5282 +8259 49 5284 5285 +8260 49 5287 5288 +8261 49 5290 5291 +8262 49 5293 5294 +8263 49 5296 5297 +8264 49 5299 5300 +8265 49 5302 5303 +8266 49 5305 5306 +8267 49 5308 5309 +8268 49 5311 5312 +8269 49 5314 5315 +8270 49 5317 5318 +8271 49 5320 5321 +8272 49 5323 5324 +8273 49 5326 5327 +8274 49 5329 5330 +8275 49 5332 5333 +8276 49 5335 5336 +8277 49 5338 5339 +8278 49 5341 5342 +8279 49 5344 5345 +8280 49 5347 5348 +8281 49 5350 5351 +8282 49 5353 5354 +8283 49 5356 5357 +8284 49 5359 5360 +8285 49 5362 5363 +8286 49 5365 5366 +8287 49 5368 5369 +8288 49 5371 5372 +8289 49 5374 5375 +8290 49 5377 5378 +8291 49 5380 5381 +8292 49 5383 5384 +8293 49 5386 5387 +8294 49 5389 5390 +8295 49 5392 5393 +8296 49 5395 5396 +8297 49 5398 5399 +8298 49 5401 5402 +8299 49 5404 5405 +8300 49 5407 5408 +8301 49 5410 5411 +8302 49 5413 5414 +8303 49 5416 5417 +8304 49 5419 5420 +8305 49 5422 5423 +8306 49 5425 5426 +8307 49 5428 5429 +8308 49 5431 5432 +8309 49 5434 5435 +8310 49 5437 5438 +8311 49 5440 5441 +8312 49 5443 5444 +8313 49 5446 5447 +8314 49 5449 5450 +8315 49 5452 5453 +8316 49 5455 5456 +8317 49 5458 5459 +8318 49 5461 5462 +8319 49 5464 5465 +8320 49 5467 5468 +8321 49 5470 5471 +8322 49 5473 5474 +8323 49 5476 5477 +8324 49 5479 5480 +8325 49 5482 5483 +8326 49 5485 5486 +8327 49 5488 5489 +8328 49 5491 5492 +8329 49 5494 5495 +8330 49 5497 5498 +8331 49 5500 5501 +8332 49 5503 5504 +8333 49 5506 5507 +8334 49 5509 5510 +8335 49 5512 5513 +8336 49 5515 5516 +8337 49 5518 5519 +8338 49 5521 5522 +8339 49 5524 5525 +8340 49 5527 5528 +8341 49 5530 5531 +8342 49 5533 5534 +8343 49 5536 5537 +8344 49 5539 5540 +8345 49 5542 5543 +8346 49 5545 5546 +8347 49 5548 5549 +8348 49 5551 5552 +8349 49 5554 5555 +8350 49 5557 5558 +8351 49 5560 5561 +8352 49 5563 5564 +8353 49 5566 5567 +8354 49 5569 5570 +8355 49 5572 5573 +8356 49 5575 5576 +8357 49 5578 5579 +8358 49 5581 5582 +8359 49 5584 5585 +8360 49 5587 5588 +8361 49 5590 5591 +8362 49 5593 5594 +8363 49 5596 5597 +8364 49 5599 5600 +8365 49 5602 5603 +8366 49 5605 5606 +8367 49 5608 5609 +8368 49 5611 5612 +8369 49 5614 5615 +8370 49 5617 5618 +8371 49 5620 5621 +8372 49 5623 5624 +8373 49 5626 5627 +8374 49 5629 5630 +8375 49 5632 5633 +8376 49 5635 5636 +8377 49 5638 5639 +8378 49 5641 5642 +8379 49 5644 5645 +8380 49 5647 5648 +8381 49 5650 5651 +8382 49 5653 5654 +8383 49 5656 5657 +8384 49 5659 5660 +8385 49 5662 5663 +8386 49 5665 5666 +8387 49 5668 5669 +8388 49 5671 5672 +8389 49 5674 5675 +8390 49 5677 5678 +8391 49 5680 5681 +8392 49 5683 5684 +8393 49 5686 5687 +8394 49 5689 5690 +8395 49 5692 5693 +8396 49 5695 5696 +8397 49 5698 5699 +8398 49 5701 5702 +8399 49 5704 5705 +8400 49 5707 5708 +8401 49 5710 5711 +8402 49 5713 5714 +8403 49 5716 5717 +8404 49 5719 5720 +8405 49 5722 5723 +8406 49 5725 5726 +8407 49 5728 5729 +8408 49 5731 5732 +8409 49 5734 5735 +8410 49 5737 5738 +8411 49 5740 5741 +8412 49 5743 5744 +8413 49 5746 5747 +8414 49 5749 5750 +8415 49 5752 5753 +8416 49 5755 5756 +8417 49 5758 5759 +8418 49 5761 5762 +8419 49 5764 5765 +8420 49 5767 5768 +8421 49 5770 5771 +8422 49 5773 5774 +8423 49 5776 5777 +8424 49 5779 5780 +8425 49 5782 5783 +8426 49 5785 5786 +8427 49 5788 5789 +8428 49 5791 5792 +8429 49 5794 5795 +8430 49 5797 5798 +8431 49 5800 5801 +8432 49 5803 5804 +8433 49 5806 5807 +8434 49 5809 5810 +8435 49 5812 5813 +8436 49 5815 5816 +8437 49 5818 5819 +8438 49 5821 5822 +8439 49 5824 5825 +8440 49 5827 5828 +8441 49 5830 5831 +8442 49 5833 5834 +8443 49 5836 5837 +8444 49 5839 5840 +8445 49 5842 5843 +8446 49 5845 5846 +8447 49 5848 5849 +8448 49 5851 5852 +8449 49 5854 5855 +8450 49 5857 5858 +8451 49 5860 5861 +8452 49 5863 5864 +8453 49 5866 5867 +8454 49 5869 5870 +8455 49 5872 5873 +8456 49 5875 5876 +8457 49 5878 5879 +8458 49 5881 5882 +8459 49 5884 5885 +8460 49 5887 5888 +8461 49 5890 5891 +8462 49 5893 5894 +8463 49 5896 5897 +8464 49 5899 5900 +8465 49 5902 5903 +8466 49 5905 5906 +8467 49 5908 5909 +8468 49 5911 5912 +8469 49 5914 5915 +8470 49 5917 5918 +8471 49 5920 5921 +8472 49 5923 5924 +8473 49 5926 5927 +8474 49 5929 5930 +8475 49 5932 5933 +8476 49 5935 5936 +8477 49 5938 5939 +8478 49 5941 5942 +8479 49 5944 5945 +8480 49 5947 5948 +8481 49 5950 5951 +8482 49 5953 5954 +8483 49 5956 5957 +8484 49 5959 5960 +8485 49 5962 5963 +8486 49 5965 5966 +8487 49 5968 5969 +8488 49 5971 5972 +8489 49 5974 5975 +8490 49 5977 5978 +8491 49 5980 5981 +8492 49 5983 5984 +8493 49 5986 5987 +8494 49 5989 5990 +8495 49 5992 5993 +8496 49 5995 5996 +8497 49 5998 5999 +8498 49 6001 6002 +8499 49 6004 6005 +8500 49 6007 6008 +8501 49 6010 6011 +8502 49 6013 6014 +8503 49 6016 6017 +8504 49 6019 6020 +8505 49 6022 6023 +8506 49 6025 6026 +8507 49 6028 6029 +8508 49 6031 6032 +8509 49 6034 6035 +8510 49 6037 6038 +8511 49 6040 6041 +8512 49 6043 6044 +8513 49 6046 6047 +8514 49 6049 6050 +8515 49 6052 6053 +8516 49 6055 6056 +8517 49 6058 6059 +8518 49 6061 6062 +8519 49 6064 6065 +8520 49 6067 6068 +8521 49 6070 6071 +8522 49 6073 6074 +8523 49 6076 6077 +8524 49 6079 6080 +8525 49 6082 6083 +8526 49 6085 6086 +8527 49 6088 6089 +8528 49 6091 6092 +8529 49 6094 6095 +8530 49 6097 6098 +8531 49 6100 6101 +8532 49 6103 6104 +8533 49 6106 6107 +8534 49 6109 6110 +8535 49 6112 6113 +8536 49 6115 6116 +8537 49 6118 6119 +8538 49 6121 6122 +8539 49 6124 6125 +8540 49 6127 6128 +8541 49 6130 6131 +8542 49 6133 6134 +8543 49 6136 6137 +8544 49 6139 6140 +8545 49 6142 6143 +8546 49 6145 6146 +8547 49 6148 6149 +8548 49 6151 6152 +8549 49 6154 6155 +8550 49 6157 6158 +8551 49 6160 6161 +8552 49 6163 6164 +8553 49 6166 6167 +8554 49 6169 6170 +8555 49 6172 6173 +8556 49 6175 6176 +8557 49 6178 6179 +8558 49 6181 6182 +8559 49 6184 6185 +8560 49 6187 6188 +8561 49 6190 6191 +8562 49 6193 6194 +8563 49 6196 6197 +8564 49 6199 6200 +8565 49 6202 6203 +8566 49 6205 6206 +8567 49 6208 6209 +8568 49 6211 6212 +8569 49 6214 6215 +8570 49 6217 6218 +8571 49 6220 6221 +8572 49 6223 6224 +8573 49 6226 6227 +8574 49 6229 6230 +8575 49 6232 6233 +8576 49 6235 6236 +8577 49 6238 6239 +8578 49 6241 6242 +8579 49 6244 6245 +8580 49 6247 6248 +8581 49 6250 6251 +8582 49 6253 6254 +8583 49 6256 6257 +8584 49 6259 6260 +8585 49 6262 6263 +8586 49 6265 6266 +8587 49 6268 6269 +8588 49 6271 6272 +8589 49 6274 6275 +8590 49 6277 6278 +8591 49 6280 6281 +8592 49 6283 6284 +8593 49 6286 6287 +8594 49 6289 6290 +8595 49 6292 6293 +8596 49 6295 6296 +8597 49 6298 6299 +8598 49 6301 6302 +8599 49 6304 6305 +8600 49 6307 6308 +8601 49 6310 6311 +8602 49 6313 6314 +8603 49 6316 6317 +8604 49 6319 6320 +8605 49 6322 6323 +8606 49 6325 6326 +8607 49 6328 6329 +8608 49 6331 6332 +8609 49 6334 6335 +8610 49 6337 6338 +8611 49 6340 6341 +8612 49 6343 6344 +8613 49 6346 6347 +8614 49 6349 6350 +8615 49 6352 6353 +8616 49 6355 6356 +8617 49 6358 6359 +8618 49 6361 6362 +8619 49 6364 6365 +8620 49 6367 6368 +8621 49 6370 6371 +8622 49 6373 6374 +8623 49 6376 6377 +8624 49 6379 6380 +8625 49 6382 6383 +8626 49 6385 6386 +8627 49 6388 6389 +8628 49 6391 6392 +8629 49 6394 6395 +8630 49 6397 6398 +8631 49 6400 6401 +8632 49 6403 6404 +8633 49 6406 6407 +8634 49 6409 6410 +8635 49 6412 6413 +8636 49 6415 6416 +8637 49 6418 6419 +8638 49 6421 6422 +8639 49 6424 6425 +8640 49 6427 6428 +8641 49 6430 6431 +8642 49 6433 6434 +8643 49 6436 6437 +8644 49 6439 6440 +8645 49 6442 6443 +8646 49 6445 6446 +8647 49 6448 6449 +8648 49 6451 6452 +8649 49 6454 6455 +8650 49 6457 6458 +8651 49 6460 6461 +8652 49 6463 6464 +8653 49 6466 6467 +8654 49 6469 6470 +8655 49 6472 6473 +8656 49 6475 6476 +8657 49 6478 6479 +8658 49 6481 6482 +8659 49 6484 6485 +8660 49 6487 6488 +8661 49 6490 6491 +8662 49 6493 6494 +8663 49 6496 6497 +8664 49 6499 6500 +8665 49 6502 6503 +8666 49 6505 6506 +8667 49 6508 6509 +8668 49 6511 6512 +8669 49 6514 6515 +8670 49 6517 6518 +8671 49 6520 6521 +8672 49 6523 6524 +8673 49 6526 6527 +8674 49 6529 6530 +8675 49 6532 6533 +8676 49 6535 6536 +8677 49 6538 6539 +8678 49 6541 6542 +8679 49 6544 6545 +8680 49 6547 6548 +8681 49 6550 6551 +8682 49 6553 6554 +8683 49 6556 6557 +8684 49 6559 6560 +8685 49 6562 6563 +8686 49 6565 6566 +8687 49 6568 6569 +8688 49 6571 6572 +8689 49 6574 6575 +8690 49 6577 6578 +8691 49 6580 6581 +8692 49 6583 6584 +8693 49 6586 6587 +8694 49 6589 6590 +8695 49 6592 6593 +8696 49 6595 6596 +8697 49 6598 6599 +8698 49 6601 6602 +8699 49 6604 6605 +8700 49 6607 6608 +8701 49 6610 6611 +8702 49 6613 6614 +8703 49 6616 6617 +8704 49 6619 6620 +8705 49 6622 6623 +8706 49 6625 6626 +8707 49 6628 6629 +8708 49 6631 6632 +8709 49 6634 6635 +8710 49 6637 6638 +8711 49 6640 6641 +8712 49 6643 6644 +8713 49 6646 6647 +8714 49 6649 6650 +8715 49 6652 6653 +8716 49 6655 6656 +8717 49 6658 6659 +8718 49 6661 6662 +8719 49 6664 6665 +8720 49 6667 6668 +8721 49 6670 6671 +8722 49 6673 6674 +8723 49 6676 6677 +8724 49 6679 6680 +8725 49 6682 6683 +8726 49 6685 6686 +8727 49 6688 6689 +8728 49 6691 6692 +8729 49 6694 6695 +8730 49 6697 6698 +8731 49 6700 6701 +8732 49 6703 6704 +8733 49 6706 6707 +8734 49 6709 6710 +8735 49 6712 6713 +8736 49 6715 6716 +8737 49 6718 6719 +8738 49 6721 6722 +8739 49 6724 6725 +8740 49 6727 6728 +8741 49 6730 6731 +8742 49 6733 6734 +8743 49 6736 6737 +8744 49 6739 6740 +8745 49 6742 6743 +8746 49 6745 6746 +8747 49 6748 6749 +8748 49 6751 6752 +8749 49 6754 6755 +8750 49 6757 6758 +8751 49 6760 6761 +8752 49 6763 6764 +8753 49 6766 6767 +8754 49 6769 6770 +8755 49 6772 6773 +8756 49 6775 6776 +8757 49 6778 6779 +8758 49 6781 6782 +8759 49 6784 6785 +8760 49 6787 6788 +8761 49 6790 6791 +8762 49 6793 6794 +8763 49 6796 6797 +8764 49 6799 6800 +8765 49 6802 6803 +8766 49 6805 6806 +8767 49 6808 6809 +8768 49 6811 6812 +8769 49 6814 6815 +8770 49 6817 6818 +8771 49 6820 6821 +8772 49 6823 6824 +8773 49 6826 6827 +8774 49 6829 6830 +8775 49 6832 6833 +8776 49 6835 6836 +8777 49 6838 6839 +8778 49 6841 6842 +8779 49 6844 6845 +8780 49 6847 6848 +8781 49 6850 6851 +8782 49 6853 6854 +8783 49 6856 6857 +8784 49 6859 6860 +8785 49 6862 6863 +8786 49 6865 6866 +8787 49 6868 6869 +8788 49 6871 6872 +8789 49 6874 6875 +8790 49 6877 6878 +8791 49 6880 6881 +8792 49 6883 6884 +8793 49 6886 6887 +8794 49 6889 6890 +8795 49 6892 6893 +8796 49 6895 6896 +8797 49 6898 6899 +8798 49 6901 6902 +8799 49 6904 6905 +8800 49 6907 6908 +8801 49 6910 6911 +8802 49 6913 6914 +8803 49 6916 6917 +8804 49 6919 6920 +8805 49 6922 6923 +8806 49 6925 6926 +8807 49 6928 6929 +8808 49 6931 6932 +8809 49 6934 6935 +8810 49 6937 6938 +8811 49 6940 6941 +8812 49 6943 6944 +8813 49 6946 6947 +8814 49 6949 6950 +8815 49 6952 6953 +8816 49 6955 6956 +8817 49 6958 6959 +8818 49 6961 6962 +8819 49 6964 6965 +8820 49 6967 6968 +8821 49 6970 6971 +8822 49 6973 6974 +8823 49 6976 6977 +8824 49 6979 6980 +8825 49 6982 6983 +8826 49 6985 6986 +8827 49 6988 6989 +8828 49 6991 6992 +8829 49 6994 6995 +8830 49 6997 6998 +8831 49 7000 7001 +8832 49 7003 7004 +8833 49 7006 7007 +8834 49 7009 7010 +8835 49 7012 7013 +8836 49 7015 7016 +8837 49 7018 7019 +8838 49 7021 7022 +8839 49 7024 7025 +8840 49 7027 7028 +8841 49 7030 7031 +8842 49 7033 7034 +8843 49 7036 7037 +8844 49 7039 7040 +8845 49 7042 7043 +8846 49 7045 7046 +8847 49 7048 7049 +8848 49 7051 7052 +8849 49 7054 7055 +8850 49 7057 7058 +8851 49 7060 7061 +8852 49 7063 7064 +8853 49 7066 7067 +8854 49 7069 7070 +8855 49 7072 7073 +8856 49 7075 7076 +8857 49 7078 7079 +8858 49 7081 7082 +8859 49 7084 7085 +8860 49 7087 7088 +8861 49 7090 7091 +8862 49 7093 7094 +8863 49 7096 7097 +8864 49 7099 7100 +8865 49 7102 7103 +8866 49 7105 7106 +8867 49 7108 7109 +8868 49 7111 7112 +8869 49 7114 7115 +8870 49 7117 7118 +8871 49 7120 7121 +8872 49 7123 7124 +8873 49 7126 7127 +8874 49 7129 7130 +8875 49 7132 7133 +8876 49 7135 7136 +8877 49 7138 7139 +8878 49 7141 7142 +8879 49 7144 7145 +8880 49 7147 7148 +8881 49 7150 7151 +8882 49 7153 7154 +8883 49 7156 7157 +8884 49 7159 7160 +8885 49 7162 7163 +8886 49 7165 7166 +8887 49 7168 7169 +8888 49 7171 7172 +8889 49 7174 7175 +8890 49 7177 7178 +8891 49 7180 7181 +8892 49 7183 7184 +8893 49 7186 7187 +8894 49 7189 7190 +8895 49 7192 7193 +8896 49 7195 7196 +8897 49 7198 7199 +8898 49 7201 7202 +8899 49 7204 7205 +8900 49 7207 7208 +8901 49 7210 7211 +8902 49 7213 7214 +8903 49 7216 7217 +8904 49 7219 7220 +8905 49 7222 7223 +8906 49 7225 7226 +8907 49 7228 7229 +8908 49 7231 7232 +8909 49 7234 7235 +8910 49 7237 7238 +8911 49 7240 7241 +8912 49 7243 7244 +8913 49 7246 7247 +8914 49 7249 7250 +8915 49 7252 7253 +8916 49 7255 7256 +8917 49 7258 7259 +8918 49 7261 7262 +8919 49 7264 7265 +8920 49 7267 7268 +8921 49 7270 7271 +8922 49 7273 7274 +8923 49 7276 7277 +8924 49 7279 7280 +8925 49 7282 7283 +8926 49 7285 7286 +8927 49 7288 7289 +8928 49 7291 7292 +8929 49 7294 7295 +8930 49 7297 7298 +8931 49 7300 7301 +8932 49 7303 7304 +8933 49 7306 7307 +8934 49 7309 7310 +8935 49 7312 7313 +8936 49 7315 7316 +8937 49 7318 7319 +8938 49 7321 7322 +8939 49 7324 7325 +8940 49 7327 7328 +8941 49 7330 7331 +8942 49 7333 7334 +8943 49 7336 7337 +8944 49 7339 7340 +8945 49 7342 7343 +8946 49 7345 7346 +8947 49 7348 7349 +8948 49 7351 7352 +8949 49 7354 7355 +8950 49 7357 7358 +8951 49 7360 7361 +8952 49 7363 7364 +8953 49 7366 7367 +8954 49 7369 7370 +8955 49 7372 7373 +8956 49 7375 7376 +8957 49 7378 7379 +8958 49 7381 7382 +8959 49 7384 7385 +8960 49 7387 7388 +8961 49 7390 7391 +8962 49 7393 7394 +8963 49 7396 7397 +8964 49 7399 7400 +8965 49 7402 7403 +8966 49 7405 7406 +8967 49 7408 7409 +8968 49 7411 7412 +8969 49 7414 7415 +8970 49 7417 7418 +8971 49 7420 7421 +8972 49 7423 7424 +8973 49 7426 7427 +8974 49 7429 7430 +8975 49 7432 7433 +8976 49 7435 7436 +8977 49 7438 7439 +8978 49 7441 7442 +8979 49 7444 7445 +8980 49 7447 7448 +8981 49 7450 7451 +8982 49 7453 7454 +8983 49 7456 7457 +8984 49 7459 7460 +8985 49 7462 7463 +8986 49 7465 7466 +8987 49 7468 7469 +8988 49 7471 7472 +8989 49 7474 7475 +8990 49 7477 7478 +8991 49 7480 7481 +8992 49 7483 7484 +8993 49 7486 7487 +8994 49 7489 7490 +8995 49 7492 7493 +8996 49 7495 7496 +8997 49 7498 7499 +8998 49 7501 7502 +8999 49 7504 7505 +9000 49 7507 7508 +9001 49 7510 7511 +9002 49 7513 7514 +9003 49 7516 7517 +9004 49 7519 7520 +9005 49 7522 7523 +9006 49 7525 7526 +9007 49 7528 7529 +9008 49 7531 7532 +9009 49 7534 7535 +9010 49 7537 7538 +9011 49 7540 7541 +9012 49 7543 7544 +9013 49 7546 7547 +9014 49 7549 7550 +9015 49 7552 7553 +9016 49 7555 7556 +9017 49 7558 7559 +9018 49 7561 7562 +9019 49 7564 7565 +9020 49 7567 7568 +9021 49 7570 7571 +9022 49 7573 7574 +9023 49 7576 7577 +9024 49 7579 7580 +9025 49 7582 7583 +9026 49 7585 7586 +9027 49 7588 7589 +9028 49 7591 7592 +9029 49 7594 7595 +9030 49 7597 7598 +9031 49 7600 7601 +9032 49 7603 7604 +9033 49 7606 7607 +9034 49 7609 7610 +9035 49 7612 7613 +9036 49 7615 7616 +9037 49 7618 7619 +9038 49 7621 7622 +9039 49 7624 7625 +9040 49 7627 7628 +9041 49 7630 7631 +9042 49 7633 7634 +9043 49 7636 7637 +9044 49 7639 7640 +9045 49 7642 7643 +9046 49 7645 7646 +9047 49 7648 7649 +9048 49 7651 7652 +9049 49 7654 7655 +9050 49 7657 7658 +9051 49 7660 7661 +9052 49 7663 7664 +9053 49 7666 7667 +9054 49 7669 7670 +9055 49 7672 7673 +9056 49 7675 7676 +9057 49 7678 7679 +9058 49 7681 7682 +9059 49 7684 7685 +9060 49 7687 7688 +9061 49 7690 7691 +9062 49 7693 7694 +9063 49 7696 7697 +9064 49 7699 7700 +9065 49 7702 7703 +9066 49 7705 7706 +9067 49 7708 7709 +9068 49 7711 7712 +9069 49 7714 7715 +9070 49 7717 7718 +9071 49 7720 7721 +9072 49 7723 7724 +9073 49 7726 7727 +9074 49 7729 7730 +9075 49 7732 7733 +9076 49 7735 7736 +9077 49 7738 7739 +9078 49 7741 7742 +9079 49 7744 7745 +9080 49 7747 7748 +9081 49 7750 7751 +9082 49 7753 7754 +9083 49 7756 7757 +9084 49 7759 7760 +9085 49 7762 7763 +9086 49 7765 7766 +9087 49 7768 7769 +9088 49 7771 7772 +9089 49 7774 7775 +9090 49 7777 7778 +9091 49 7780 7781 +9092 49 7783 7784 +9093 49 7786 7787 +9094 49 7789 7790 +9095 49 7792 7793 +9096 49 7795 7796 +9097 49 7798 7799 +9098 49 7801 7802 +9099 49 7804 7805 +9100 49 7807 7808 +9101 49 7810 7811 +9102 49 7813 7814 +9103 49 7816 7817 +9104 49 7819 7820 +9105 49 7822 7823 +9106 49 7825 7826 +9107 49 7828 7829 +9108 49 7831 7832 +9109 49 7834 7835 +9110 49 7837 7838 +9111 49 7840 7841 +9112 49 7843 7844 +9113 49 7846 7847 +9114 49 7849 7850 +9115 49 7852 7853 +9116 49 7855 7856 +9117 49 7858 7859 +9118 49 7861 7862 +9119 49 7864 7865 +9120 49 7867 7868 +9121 49 7870 7871 +9122 49 7873 7874 +9123 49 7876 7877 +9124 49 7879 7880 +9125 49 7882 7883 +9126 49 7885 7886 +9127 49 7888 7889 +9128 49 7891 7892 +9129 49 7894 7895 +9130 49 7897 7898 +9131 49 7900 7901 +9132 49 7903 7904 +9133 49 7906 7907 +9134 49 7909 7910 +9135 49 7912 7913 +9136 49 7915 7916 +9137 49 7918 7919 +9138 49 7921 7922 +9139 49 7924 7925 +9140 49 7927 7928 +9141 49 7930 7931 +9142 49 7933 7934 +9143 49 7936 7937 +9144 49 7939 7940 +9145 49 7942 7943 +9146 49 7945 7946 +9147 49 7948 7949 +9148 49 7951 7952 +9149 49 7954 7955 +9150 49 7957 7958 +9151 49 7960 7961 +9152 49 7963 7964 +9153 49 7966 7967 +9154 49 7969 7970 +9155 49 7972 7973 +9156 49 7975 7976 +9157 49 7978 7979 +9158 49 7981 7982 +9159 49 7984 7985 +9160 49 7987 7988 +9161 49 7990 7991 +9162 49 7993 7994 +9163 49 7996 7997 +9164 49 7999 8000 +9165 49 8002 8003 +9166 49 8005 8006 +9167 49 8008 8009 +9168 49 8011 8012 +9169 49 8014 8015 +9170 49 8017 8018 +9171 49 8020 8021 +9172 49 8023 8024 +9173 49 8026 8027 +9174 49 8029 8030 +9175 49 8032 8033 +9176 49 8035 8036 +9177 49 8038 8039 +9178 49 8041 8042 +9179 49 8044 8045 +9180 49 8047 8048 +9181 49 8050 8051 +9182 49 8053 8054 +9183 49 8056 8057 +9184 49 8059 8060 +9185 49 8062 8063 +9186 49 8065 8066 +9187 49 8068 8069 +9188 49 8071 8072 +9189 49 8074 8075 +9190 49 8077 8078 +9191 49 8080 8081 +9192 49 8083 8084 +9193 49 8086 8087 +9194 49 8089 8090 +9195 49 8092 8093 +9196 49 8095 8096 +9197 49 8098 8099 +9198 49 8101 8102 +9199 49 8104 8105 +9200 49 8107 8108 +9201 49 8110 8111 +9202 49 8113 8114 +9203 49 8116 8117 +9204 49 8119 8120 +9205 49 8122 8123 +9206 49 8125 8126 +9207 49 8128 8129 +9208 49 8131 8132 +9209 49 8134 8135 +9210 49 8137 8138 +9211 49 8140 8141 +9212 49 8143 8144 +9213 49 8146 8147 +9214 49 8149 8150 +9215 49 8152 8153 +9216 49 8155 8156 +9217 49 8158 8159 +9218 49 8161 8162 +9219 49 8164 8165 +9220 49 8167 8168 +9221 49 8170 8171 +9222 49 8173 8174 +9223 49 8176 8177 +9224 49 8179 8180 +9225 49 8182 8183 +9226 49 8185 8186 +9227 49 8188 8189 +9228 49 8191 8192 +9229 49 8194 8195 +9230 49 8197 8198 +9231 49 8200 8201 +9232 49 8203 8204 +9233 49 8206 8207 +9234 49 8209 8210 +9235 49 8212 8213 +9236 49 8215 8216 +9237 49 8218 8219 +9238 49 8221 8222 +9239 49 8224 8225 +9240 49 8227 8228 +9241 49 8230 8231 +9242 49 8233 8234 +9243 49 8236 8237 +9244 49 8239 8240 +9245 49 8242 8243 +9246 49 8245 8246 +9247 49 8248 8249 +9248 49 8251 8252 +9249 49 8254 8255 +9250 49 8257 8258 +9251 49 8260 8261 +9252 49 8263 8264 +9253 49 8266 8267 +9254 49 8269 8270 +9255 49 8272 8273 +9256 49 8275 8276 +9257 49 8278 8279 +9258 49 8281 8282 +9259 49 8284 8285 +9260 49 8287 8288 +9261 49 8290 8291 +9262 49 8293 8294 +9263 49 8296 8297 +9264 49 8299 8300 +9265 49 8302 8303 +9266 49 8305 8306 +9267 49 8308 8309 +9268 49 8311 8312 +9269 49 8314 8315 +9270 49 8317 8318 +9271 49 8320 8321 +9272 49 8323 8324 +9273 49 8326 8327 +9274 49 8329 8330 +9275 49 8332 8333 +9276 49 8335 8336 +9277 49 8338 8339 +9278 49 8341 8342 +9279 49 8344 8345 +9280 49 8347 8348 +9281 49 8350 8351 +9282 49 8353 8354 +9283 49 8356 8357 +9284 49 8359 8360 +9285 49 8362 8363 +9286 49 8365 8366 +9287 49 8368 8369 +9288 49 8371 8372 +9289 49 8374 8375 +9290 49 8377 8378 +9291 49 8380 8381 +9292 49 8383 8384 +9293 49 8386 8387 +9294 49 8389 8390 +9295 49 8392 8393 +9296 49 8395 8396 +9297 49 8398 8399 +9298 49 8401 8402 +9299 49 8404 8405 +9300 49 8407 8408 +9301 49 8410 8411 +9302 49 8413 8414 +9303 49 8416 8417 +9304 49 8419 8420 +9305 49 8422 8423 +9306 49 8425 8426 +9307 49 8428 8429 +9308 49 8431 8432 +9309 49 8434 8435 +9310 49 8437 8438 +9311 49 8440 8441 +9312 49 8443 8444 +9313 49 8446 8447 +9314 49 8449 8450 +9315 49 8452 8453 +9316 49 8455 8456 +9317 49 8458 8459 +9318 49 8461 8462 +9319 49 8464 8465 +9320 49 8467 8468 +9321 49 8470 8471 +9322 49 8473 8474 +9323 49 8476 8477 +9324 49 8479 8480 +9325 49 8482 8483 +9326 49 8485 8486 +9327 49 8488 8489 +9328 49 8491 8492 +9329 49 8494 8495 +9330 49 8497 8498 +9331 49 8500 8501 +9332 49 8503 8504 +9333 49 8506 8507 +9334 49 8509 8510 +9335 49 8512 8513 +9336 49 8515 8516 +9337 49 8518 8519 +9338 49 8521 8522 +9339 49 8524 8525 +9340 49 8527 8528 +9341 49 8530 8531 +9342 49 8533 8534 +9343 49 8536 8537 +9344 49 8539 8540 +9345 49 8542 8543 +9346 49 8545 8546 +9347 49 8548 8549 +9348 49 8551 8552 +9349 49 8554 8555 +9350 49 8557 8558 +9351 49 8560 8561 +9352 49 8563 8564 +9353 49 8566 8567 +9354 49 8569 8570 +9355 49 8572 8573 +9356 49 8575 8576 +9357 49 8578 8579 +9358 49 8581 8582 +9359 49 8584 8585 +9360 49 8587 8588 +9361 49 8590 8591 +9362 49 8593 8594 +9363 49 8596 8597 +9364 49 8599 8600 +9365 49 8602 8603 +9366 49 8605 8606 +9367 49 8608 8609 +9368 49 8611 8612 +9369 49 8614 8615 +9370 49 8617 8618 +9371 49 8620 8621 +9372 49 8623 8624 +9373 49 8626 8627 +9374 49 8629 8630 +9375 49 8632 8633 +9376 49 8635 8636 +9377 49 8638 8639 +9378 49 8641 8642 +9379 49 8644 8645 +9380 49 8647 8648 +9381 49 8650 8651 +9382 49 8653 8654 +9383 49 8656 8657 +9384 49 8659 8660 +9385 49 8662 8663 +9386 49 8665 8666 +9387 49 8668 8669 +9388 49 8671 8672 +9389 49 8674 8675 +9390 49 8677 8678 +9391 49 8680 8681 +9392 49 8683 8684 +9393 49 8686 8687 +9394 49 8689 8690 +9395 49 8692 8693 +9396 49 8695 8696 +9397 49 8698 8699 +9398 49 8701 8702 +9399 49 8704 8705 +9400 49 8707 8708 +9401 49 8710 8711 +9402 49 8713 8714 +9403 49 8716 8717 +9404 49 8719 8720 +9405 49 8722 8723 +9406 49 8725 8726 +9407 49 8728 8729 +9408 49 8731 8732 +9409 49 8734 8735 +9410 49 8737 8738 +9411 49 8740 8741 +9412 49 8743 8744 +9413 49 8746 8747 +9414 49 8749 8750 +9415 49 8752 8753 +9416 49 8755 8756 +9417 49 8758 8759 +9418 49 8761 8762 +9419 49 8764 8765 +9420 49 8767 8768 +9421 49 8770 8771 +9422 49 8773 8774 +9423 49 8776 8777 +9424 49 8779 8780 +9425 49 8782 8783 +9426 49 8785 8786 +9427 49 8788 8789 +9428 49 8791 8792 +9429 49 8794 8795 +9430 49 8797 8798 +9431 49 8800 8801 +9432 49 8803 8804 +9433 49 8806 8807 +9434 49 8809 8810 +9435 49 8812 8813 +9436 49 8815 8816 +9437 49 8818 8819 +9438 49 8821 8822 +9439 49 8824 8825 +9440 49 8827 8828 +9441 49 8830 8831 +9442 49 8833 8834 +9443 49 8836 8837 +9444 49 8839 8840 +9445 49 8842 8843 +9446 49 8845 8846 +9447 49 8848 8849 +9448 49 8851 8852 +9449 49 8854 8855 +9450 49 8857 8858 +9451 49 8860 8861 +9452 49 8863 8864 +9453 49 8866 8867 +9454 49 8869 8870 +9455 49 8872 8873 +9456 49 8875 8876 +9457 49 8878 8879 +9458 49 8881 8882 +9459 49 8884 8885 +9460 49 8887 8888 +9461 49 8890 8891 +9462 49 8893 8894 +9463 49 8896 8897 +9464 49 8899 8900 +9465 49 8902 8903 +9466 49 8905 8906 +9467 49 8908 8909 +9468 49 8911 8912 +9469 49 8914 8915 +9470 49 8917 8918 +9471 49 8920 8921 +9472 49 8923 8924 +9473 49 8926 8927 +9474 49 8929 8930 +9475 49 8932 8933 +9476 49 8935 8936 +9477 49 8938 8939 +9478 49 8941 8942 +9479 49 8944 8945 +9480 49 8947 8948 +9481 49 8950 8951 +9482 49 8953 8954 +9483 49 8956 8957 +9484 49 8959 8960 +9485 49 8962 8963 +9486 49 8965 8966 +9487 49 8968 8969 +9488 49 8971 8972 +9489 49 8974 8975 +9490 49 8977 8978 +9491 49 8980 8981 +9492 49 8983 8984 +9493 49 8986 8987 +9494 49 8989 8990 +9495 49 8992 8993 +9496 49 8995 8996 +9497 49 8998 8999 +9498 49 9001 9002 +9499 49 9004 9005 +9500 49 9007 9008 +9501 49 9010 9011 +9502 49 9013 9014 +9503 49 9016 9017 +9504 49 9019 9020 +9505 49 9022 9023 +9506 49 9025 9026 +9507 49 9028 9029 +9508 49 9031 9032 +9509 49 9034 9035 +9510 49 9037 9038 +9511 49 9040 9041 +9512 49 9043 9044 +9513 49 9046 9047 +9514 49 9049 9050 +9515 49 9052 9053 +9516 49 9055 9056 +9517 49 9058 9059 +9518 49 9061 9062 +9519 49 9064 9065 +9520 49 9067 9068 +9521 49 9070 9071 +9522 49 9073 9074 +9523 49 9076 9077 +9524 49 9079 9080 +9525 49 9082 9083 +9526 49 9085 9086 +9527 49 9088 9089 +9528 49 9091 9092 +9529 49 9094 9095 +9530 49 9097 9098 +9531 49 9100 9101 +9532 49 9103 9104 +9533 49 9106 9107 +9534 49 9109 9110 +9535 49 9112 9113 +9536 49 9115 9116 +9537 49 9118 9119 +9538 49 9121 9122 +9539 49 9124 9125 +9540 49 9127 9128 +9541 49 9130 9131 +9542 49 9133 9134 +9543 49 9136 9137 +9544 49 9139 9140 +9545 49 9142 9143 +9546 49 9145 9146 +9547 49 9148 9149 +9548 49 9151 9152 +9549 49 9154 9155 +9550 49 9157 9158 +9551 49 9160 9161 +9552 49 9163 9164 +9553 49 9166 9167 +9554 49 9169 9170 +9555 49 9172 9173 +9556 49 9175 9176 +9557 49 9178 9179 +9558 49 9181 9182 +9559 49 9184 9185 +9560 49 9187 9188 +9561 49 9190 9191 +9562 49 9193 9194 +9563 49 9196 9197 +9564 49 9199 9200 +9565 49 9202 9203 +9566 49 9205 9206 +9567 49 9208 9209 +9568 49 9211 9212 +9569 49 9214 9215 +9570 49 9217 9218 +9571 49 9220 9221 +9572 49 9223 9224 +9573 49 9226 9227 +9574 49 9229 9230 +9575 49 9232 9233 +9576 49 9235 9236 +9577 49 9238 9239 +9578 49 9241 9242 +9579 49 9244 9245 +9580 49 9247 9248 +9581 49 9250 9251 +9582 49 9253 9254 +9583 49 9256 9257 +9584 49 9259 9260 +9585 49 9262 9263 +9586 49 9265 9266 +9587 49 9268 9269 +9588 49 9271 9272 +9589 49 9274 9275 +9590 49 9277 9278 +9591 49 9280 9281 +9592 49 9283 9284 +9593 49 9286 9287 +9594 49 9289 9290 +9595 49 9292 9293 +9596 49 9295 9296 +9597 49 9298 9299 +9598 49 9301 9302 +9599 49 9304 9305 +9600 49 9307 9308 +9601 49 9310 9311 +9602 49 9313 9314 +9603 49 9316 9317 +9604 49 9319 9320 +9605 49 9322 9323 +9606 49 9325 9326 +9607 49 9328 9329 +9608 49 9331 9332 +9609 49 9334 9335 +9610 49 9337 9338 +9611 49 9340 9341 +9612 49 9343 9344 +9613 49 9346 9347 +9614 49 9349 9350 +9615 49 9352 9353 +9616 49 9355 9356 +9617 49 9358 9359 +9618 49 9361 9362 +9619 49 9364 9365 +9620 49 9367 9368 +9621 49 9370 9371 +9622 49 9373 9374 +9623 49 9376 9377 +9624 49 9379 9380 +9625 49 9382 9383 +9626 49 9385 9386 +9627 49 9388 9389 +9628 49 9391 9392 +9629 49 9394 9395 +9630 49 9397 9398 +9631 49 9400 9401 +9632 49 9403 9404 +9633 49 9406 9407 +9634 49 9409 9410 +9635 49 9412 9413 +9636 49 9415 9416 +9637 49 9418 9419 +9638 49 9421 9422 +9639 49 9424 9425 +9640 49 9427 9428 +9641 49 9430 9431 +9642 49 9433 9434 +9643 49 9436 9437 +9644 49 9439 9440 +9645 49 9442 9443 +9646 49 9445 9446 +9647 49 9448 9449 +9648 49 9451 9452 +9649 49 9454 9455 +9650 49 9457 9458 +9651 49 9460 9461 +9652 49 9463 9464 +9653 49 9466 9467 +9654 49 9469 9470 +9655 49 9472 9473 +9656 49 9475 9476 +9657 49 9478 9479 +9658 49 9481 9482 +9659 49 9484 9485 +9660 49 9487 9488 +9661 49 9490 9491 +9662 49 9493 9494 +9663 49 9496 9497 +9664 49 9499 9500 +9665 49 9502 9503 +9666 49 9505 9506 +9667 49 9508 9509 +9668 49 9511 9512 +9669 49 9514 9515 +9670 49 9517 9518 +9671 49 9520 9521 +9672 49 9523 9524 +9673 49 9526 9527 +9674 49 9529 9530 +9675 49 9532 9533 +9676 49 9535 9536 +9677 49 9538 9539 +9678 49 9541 9542 +9679 49 9544 9545 +9680 49 9547 9548 +9681 49 9550 9551 +9682 49 9553 9554 +9683 49 9556 9557 +9684 49 9559 9560 +9685 49 9562 9563 +9686 49 9565 9566 +9687 49 9568 9569 +9688 49 9571 9572 +9689 49 9574 9575 +9690 49 9577 9578 +9691 49 9580 9581 +9692 49 9583 9584 +9693 49 9586 9587 +9694 49 9589 9590 +9695 49 9592 9593 +9696 49 9595 9596 +9697 49 9598 9599 +9698 49 9601 9602 +9699 49 9604 9605 +9700 49 9607 9608 +9701 49 9610 9611 +9702 49 9613 9614 +9703 49 9616 9617 +9704 49 9619 9620 +9705 49 9622 9623 +9706 49 9625 9626 +9707 49 9628 9629 +9708 49 9631 9632 +9709 49 9634 9635 +9710 49 9637 9638 +9711 49 9640 9641 +9712 49 9643 9644 +9713 49 9646 9647 +9714 49 9649 9650 +9715 49 9652 9653 +9716 49 9655 9656 +9717 49 9658 9659 +9718 49 9661 9662 +9719 49 9664 9665 +9720 49 9667 9668 +9721 49 9670 9671 +9722 49 9673 9674 +9723 49 9676 9677 +9724 49 9679 9680 +9725 49 9682 9683 +9726 49 9685 9686 +9727 49 9688 9689 +9728 49 9691 9692 +9729 49 9694 9695 +9730 49 9697 9698 +9731 49 9700 9701 +9732 49 9703 9704 +9733 49 9706 9707 +9734 49 9709 9710 +9735 49 9712 9713 +9736 49 9715 9716 +9737 49 9718 9719 +9738 49 9721 9722 +9739 49 9724 9725 +9740 49 9727 9728 +9741 49 9730 9731 +9742 49 9733 9734 +9743 49 9736 9737 + +Angles + +1 1 2 1 5 +2 1 2 1 6 +3 1 2 1 7 +4 2 6 1 5 +5 2 7 1 5 +6 2 7 1 6 +7 3 3 2 1 +8 4 8 2 1 +9 5 9 2 1 +10 6 3 2 8 +11 7 3 2 9 +12 8 8 2 9 +13 9 4 3 2 +14 10 20 3 2 +15 11 20 3 4 +16 12 2 9 10 +17 13 2 9 13 +18 13 2 9 14 +19 14 10 9 13 +20 14 10 9 14 +21 15 14 9 13 +22 16 9 10 11 +23 14 9 10 15 +24 14 9 10 16 +25 17 15 10 11 +26 17 16 10 11 +27 15 16 10 15 +28 18 12 11 10 +29 19 17 12 11 +30 19 18 12 11 +31 19 19 12 11 +32 15 18 12 17 +33 15 19 12 17 +34 15 19 12 18 +35 20 3 20 21 +36 21 3 20 24 +37 22 24 20 21 +38 23 20 21 22 +39 24 20 21 25 +40 25 20 21 26 +41 6 22 21 25 +42 7 22 21 26 +43 8 25 21 26 +44 9 23 22 21 +45 10 37 22 21 +46 11 37 22 23 +47 12 21 26 27 +48 13 21 26 31 +49 13 21 26 32 +50 14 27 26 31 +51 14 27 26 32 +52 15 32 26 31 +53 26 28 27 26 +54 14 26 27 33 +55 14 26 27 34 +56 27 28 27 33 +57 27 28 27 34 +58 15 34 27 33 +59 28 29 28 27 +60 29 30 28 27 +61 11 30 28 29 +62 21 28 30 35 +63 21 28 30 36 +64 30 36 30 35 +65 20 22 37 38 +66 21 22 37 41 +67 22 41 37 38 +68 23 37 38 39 +69 24 37 38 42 +70 31 37 38 43 +71 6 39 38 42 +72 32 39 38 43 +73 33 42 38 43 +74 9 40 39 38 +75 10 56 39 38 +76 11 56 39 40 +77 34 38 43 44 +78 34 38 43 45 +79 33 47 43 38 +80 35 45 43 44 +81 8 47 43 44 +82 8 47 43 45 +83 12 43 44 46 +84 13 43 44 48 +85 13 43 44 49 +86 14 46 44 48 +87 14 46 44 49 +88 15 49 44 48 +89 13 43 45 50 +90 13 43 45 51 +91 13 43 45 52 +92 15 51 45 50 +93 15 52 45 50 +94 15 52 45 51 +95 14 44 46 53 +96 14 44 46 54 +97 14 44 46 55 +98 15 54 46 53 +99 15 55 46 53 +100 15 55 46 54 +101 20 39 56 57 +102 21 39 56 60 +103 22 60 56 57 +104 23 56 57 58 +105 24 56 57 61 +106 25 56 57 62 +107 6 58 57 61 +108 7 58 57 62 +109 8 61 57 62 +110 9 59 58 57 +111 10 76 58 57 +112 11 76 58 59 +113 36 57 62 63 +114 13 57 62 69 +115 13 57 62 70 +116 37 69 62 63 +117 37 70 62 63 +118 15 70 62 69 +119 38 62 63 64 +120 38 62 63 65 +121 39 65 63 64 +122 39 66 64 63 +123 40 63 64 71 +124 40 66 64 71 +125 39 67 65 63 +126 40 63 65 72 +127 40 67 65 72 +128 39 68 66 64 +129 40 64 66 73 +130 40 68 66 73 +131 39 68 67 65 +132 40 65 67 74 +133 40 68 67 74 +134 39 67 68 66 +135 40 66 68 75 +136 40 67 68 75 +137 20 58 76 77 +138 21 58 76 80 +139 22 80 76 77 +140 23 76 77 78 +141 24 76 77 81 +142 31 76 77 82 +143 6 78 77 81 +144 32 78 77 82 +145 33 81 77 82 +146 9 79 78 77 +147 10 92 78 77 +148 11 92 78 79 +149 34 77 82 83 +150 34 77 82 84 +151 33 85 82 77 +152 35 84 82 83 +153 8 85 82 83 +154 8 85 82 84 +155 13 82 83 86 +156 13 82 83 87 +157 13 82 83 88 +158 15 87 83 86 +159 15 88 83 86 +160 15 88 83 87 +161 13 82 84 89 +162 13 82 84 90 +163 13 82 84 91 +164 15 90 84 89 +165 15 91 84 89 +166 15 91 84 90 +167 20 78 92 93 +168 21 78 92 96 +169 22 96 92 93 +170 23 92 93 94 +171 24 92 93 97 +172 25 92 93 98 +173 6 94 93 97 +174 7 94 93 98 +175 8 97 93 98 +176 9 95 94 93 +177 10 114 94 93 +178 11 114 94 95 +179 12 93 98 99 +180 13 93 98 103 +181 13 93 98 104 +182 14 99 98 103 +183 14 99 98 104 +184 15 104 98 103 +185 41 100 99 98 +186 14 98 99 105 +187 14 98 99 106 +188 14 100 99 105 +189 14 100 99 106 +190 15 106 99 105 +191 41 101 100 99 +192 14 99 100 107 +193 14 99 100 108 +194 14 101 100 107 +195 14 101 100 108 +196 15 108 100 107 +197 42 100 101 102 +198 14 100 101 109 +199 14 100 101 110 +200 43 109 101 102 +201 43 110 101 102 +202 15 110 101 109 +203 44 101 102 111 +204 44 101 102 112 +205 44 101 102 113 +206 45 112 102 111 +207 45 113 102 111 +208 45 113 102 112 +209 20 94 114 115 +210 21 94 114 118 +211 22 118 114 115 +212 23 114 115 116 +213 24 114 115 119 +214 31 114 115 120 +215 6 116 115 119 +216 32 116 115 120 +217 33 119 115 120 +218 9 117 116 115 +219 10 128 116 115 +220 11 128 116 117 +221 46 115 120 121 +222 34 115 120 122 +223 33 123 120 115 +224 47 122 120 121 +225 48 123 120 121 +226 8 123 120 122 +227 49 120 121 124 +228 13 120 122 125 +229 13 120 122 126 +230 13 120 122 127 +231 15 126 122 125 +232 15 127 122 125 +233 15 127 122 126 +234 20 116 128 129 +235 21 116 128 132 +236 22 132 128 129 +237 23 128 129 130 +238 24 128 129 133 +239 25 128 129 134 +240 6 130 129 133 +241 7 130 129 134 +242 8 133 129 134 +243 9 131 130 129 +244 10 147 130 129 +245 11 147 130 131 +246 50 135 134 129 +247 13 129 134 138 +248 13 129 134 139 +249 13 135 134 138 +250 13 135 134 139 +251 15 139 134 138 +252 35 136 135 134 +253 35 137 135 134 +254 8 140 135 134 +255 35 137 135 136 +256 8 140 135 136 +257 8 140 135 137 +258 13 135 136 141 +259 13 135 136 142 +260 13 135 136 143 +261 15 142 136 141 +262 15 143 136 141 +263 15 143 136 142 +264 13 135 137 144 +265 13 135 137 145 +266 13 135 137 146 +267 15 145 137 144 +268 15 146 137 144 +269 15 146 137 145 +270 20 130 147 148 +271 21 130 147 151 +272 22 151 147 148 +273 23 147 148 149 +274 24 147 148 152 +275 31 147 148 153 +276 6 149 148 152 +277 32 149 148 153 +278 33 152 148 153 +279 9 150 149 148 +280 10 161 149 148 +281 11 161 149 150 +282 46 148 153 154 +283 34 148 153 155 +284 33 156 153 148 +285 47 155 153 154 +286 48 156 153 154 +287 8 156 153 155 +288 49 153 154 157 +289 13 153 155 158 +290 13 153 155 159 +291 13 153 155 160 +292 15 159 155 158 +293 15 160 155 158 +294 15 160 155 159 +295 51 162 161 149 +296 21 149 161 165 +297 52 162 161 165 +298 53 161 162 163 +299 54 161 162 166 +300 54 161 162 167 +301 55 163 162 166 +302 55 163 162 167 +303 56 167 162 166 +304 57 162 163 164 +305 58 168 163 162 +306 11 168 163 164 +307 20 163 168 169 +308 21 163 168 172 +309 22 172 168 169 +310 23 168 169 170 +311 24 168 169 173 +312 25 168 169 174 +313 6 170 169 173 +314 7 170 169 174 +315 8 173 169 174 +316 9 171 170 169 +317 10 190 170 169 +318 11 190 170 171 +319 12 169 174 175 +320 13 169 174 179 +321 13 169 174 180 +322 14 175 174 179 +323 14 175 174 180 +324 15 180 174 179 +325 41 176 175 174 +326 14 174 175 181 +327 14 174 175 182 +328 14 176 175 181 +329 14 176 175 182 +330 15 182 175 181 +331 41 177 176 175 +332 14 175 176 183 +333 14 175 176 184 +334 14 177 176 183 +335 14 177 176 184 +336 15 184 176 183 +337 42 176 177 178 +338 14 176 177 185 +339 14 176 177 186 +340 43 185 177 178 +341 43 186 177 178 +342 15 186 177 185 +343 44 177 178 187 +344 44 177 178 188 +345 44 177 178 189 +346 45 188 178 187 +347 45 189 178 187 +348 45 189 178 188 +349 20 170 190 191 +350 21 170 190 194 +351 22 194 190 191 +352 23 190 191 192 +353 24 190 191 195 +354 31 190 191 196 +355 6 192 191 195 +356 32 192 191 196 +357 33 195 191 196 +358 9 193 192 191 +359 10 204 192 191 +360 11 204 192 193 +361 46 191 196 197 +362 34 191 196 198 +363 33 199 196 191 +364 47 198 196 197 +365 48 199 196 197 +366 8 199 196 198 +367 49 196 197 200 +368 13 196 198 201 +369 13 196 198 202 +370 13 196 198 203 +371 15 202 198 201 +372 15 203 198 201 +373 15 203 198 202 +374 20 192 204 205 +375 21 192 204 208 +376 22 208 204 205 +377 23 204 205 206 +378 24 204 205 209 +379 31 204 205 210 +380 6 206 205 209 +381 32 206 205 210 +382 33 209 205 210 +383 9 207 206 205 +384 10 223 206 205 +385 11 223 206 207 +386 34 205 210 211 +387 34 205 210 212 +388 33 214 210 205 +389 35 212 210 211 +390 8 214 210 211 +391 8 214 210 212 +392 12 210 211 213 +393 13 210 211 215 +394 13 210 211 216 +395 14 213 211 215 +396 14 213 211 216 +397 15 216 211 215 +398 13 210 212 217 +399 13 210 212 218 +400 13 210 212 219 +401 15 218 212 217 +402 15 219 212 217 +403 15 219 212 218 +404 14 211 213 220 +405 14 211 213 221 +406 14 211 213 222 +407 15 221 213 220 +408 15 222 213 220 +409 15 222 213 221 +410 20 206 223 224 +411 21 206 223 227 +412 22 227 223 224 +413 23 223 224 225 +414 24 223 224 228 +415 31 223 224 229 +416 6 225 224 228 +417 32 225 224 229 +418 33 228 224 229 +419 9 226 225 224 +420 10 237 225 224 +421 11 237 225 226 +422 46 224 229 230 +423 34 224 229 231 +424 33 232 229 224 +425 47 231 229 230 +426 48 232 229 230 +427 8 232 229 231 +428 49 229 230 233 +429 13 229 231 234 +430 13 229 231 235 +431 13 229 231 236 +432 15 235 231 234 +433 15 236 231 234 +434 15 236 231 235 +435 20 225 237 238 +436 21 225 237 241 +437 22 241 237 238 +438 23 237 238 239 +439 24 237 238 242 +440 25 237 238 243 +441 6 239 238 242 +442 7 239 238 243 +443 8 242 238 243 +444 9 240 239 238 +445 10 256 239 238 +446 11 256 239 240 +447 50 244 243 238 +448 13 238 243 247 +449 13 238 243 248 +450 13 244 243 247 +451 13 244 243 248 +452 15 248 243 247 +453 35 245 244 243 +454 35 246 244 243 +455 8 249 244 243 +456 35 246 244 245 +457 8 249 244 245 +458 8 249 244 246 +459 13 244 245 250 +460 13 244 245 251 +461 13 244 245 252 +462 15 251 245 250 +463 15 252 245 250 +464 15 252 245 251 +465 13 244 246 253 +466 13 244 246 254 +467 13 244 246 255 +468 15 254 246 253 +469 15 255 246 253 +470 15 255 246 254 +471 20 239 256 257 +472 21 239 256 260 +473 22 260 256 257 +474 23 256 257 258 +475 24 256 257 261 +476 25 256 257 262 +477 6 258 257 261 +478 7 258 257 262 +479 8 261 257 262 +480 9 259 258 257 +481 10 271 258 257 +482 11 271 258 259 +483 12 257 262 263 +484 13 257 262 267 +485 13 257 262 268 +486 14 263 262 267 +487 14 263 262 268 +488 15 268 262 267 +489 59 262 263 264 +490 14 262 263 269 +491 14 262 263 270 +492 60 269 263 264 +493 60 270 263 264 +494 15 270 263 269 +495 61 263 264 265 +496 61 263 264 266 +497 62 266 264 265 +498 20 258 271 272 +499 21 258 271 275 +500 22 275 271 272 +501 23 271 272 273 +502 24 271 272 276 +503 31 271 272 277 +504 6 273 272 276 +505 32 273 272 277 +506 33 276 272 277 +507 9 274 273 272 +508 10 287 273 272 +509 11 287 273 274 +510 34 272 277 278 +511 34 272 277 279 +512 33 280 277 272 +513 35 279 277 278 +514 8 280 277 278 +515 8 280 277 279 +516 13 277 278 281 +517 13 277 278 282 +518 13 277 278 283 +519 15 282 278 281 +520 15 283 278 281 +521 15 283 278 282 +522 13 277 279 284 +523 13 277 279 285 +524 13 277 279 286 +525 15 285 279 284 +526 15 286 279 284 +527 15 286 279 285 +528 20 273 287 288 +529 21 273 287 291 +530 22 291 287 288 +531 23 287 288 289 +532 24 287 288 292 +533 25 287 288 293 +534 6 289 288 292 +535 7 289 288 293 +536 8 292 288 293 +537 9 290 289 288 +538 63 288 289 302 +539 64 290 289 302 +540 12 288 293 294 +541 13 288 293 298 +542 13 288 293 299 +543 14 294 293 298 +544 14 294 293 299 +545 15 299 293 298 +546 59 293 294 295 +547 14 293 294 300 +548 14 293 294 301 +549 60 300 294 295 +550 60 301 294 295 +551 15 301 294 300 +552 61 294 295 296 +553 61 294 295 297 +554 62 297 295 296 +555 65 289 302 303 +556 66 289 302 309 +557 67 303 302 309 +558 68 304 303 302 +559 69 306 303 302 +560 70 302 303 307 +561 6 304 303 306 +562 71 304 303 307 +563 72 306 303 307 +564 9 305 304 303 +565 10 316 304 303 +566 11 316 304 305 +567 73 303 307 308 +568 74 303 307 310 +569 74 303 307 311 +570 75 310 307 308 +571 75 311 307 308 +572 76 311 307 310 +573 77 309 308 307 +574 75 312 308 307 +575 75 313 308 307 +576 75 312 308 309 +577 75 313 308 309 +578 76 313 308 312 +579 78 302 309 308 +580 79 314 309 302 +581 79 315 309 302 +582 80 314 309 308 +583 80 315 309 308 +584 81 315 309 314 +585 20 304 316 317 +586 21 304 316 320 +587 22 320 316 317 +588 23 316 317 318 +589 24 316 317 321 +590 25 316 317 322 +591 6 318 317 321 +592 7 318 317 322 +593 8 321 317 322 +594 9 319 318 317 +595 10 327 318 317 +596 11 327 318 319 +597 82 317 322 323 +598 13 317 322 324 +599 13 317 322 325 +600 83 324 322 323 +601 83 325 322 323 +602 15 325 322 324 +603 84 322 323 326 +604 20 318 327 328 +605 21 318 327 331 +606 22 331 327 328 +607 23 327 328 329 +608 24 327 328 332 +609 25 327 328 333 +610 6 329 328 332 +611 7 329 328 333 +612 8 332 328 333 +613 9 330 329 328 +614 10 339 329 328 +615 11 339 329 330 +616 85 328 333 334 +617 13 328 333 337 +618 13 328 333 338 +619 60 337 333 334 +620 60 338 333 334 +621 15 338 333 337 +622 61 333 334 335 +623 61 333 334 336 +624 62 336 334 335 +625 20 329 339 340 +626 21 329 339 343 +627 22 343 339 340 +628 23 339 340 341 +629 24 339 340 344 +630 31 339 340 345 +631 6 341 340 344 +632 32 341 340 345 +633 33 344 340 345 +634 9 342 341 340 +635 10 353 341 340 +636 11 353 341 342 +637 46 340 345 346 +638 34 340 345 347 +639 33 348 345 340 +640 47 347 345 346 +641 48 348 345 346 +642 8 348 345 347 +643 49 345 346 349 +644 13 345 347 350 +645 13 345 347 351 +646 13 345 347 352 +647 15 351 347 350 +648 15 352 347 350 +649 15 352 347 351 +650 20 341 353 354 +651 21 341 353 357 +652 22 357 353 354 +653 23 353 354 355 +654 24 353 354 358 +655 31 353 354 359 +656 6 355 354 358 +657 32 355 354 359 +658 33 358 354 359 +659 9 356 355 354 +660 10 372 355 354 +661 11 372 355 356 +662 34 354 359 360 +663 34 354 359 361 +664 33 363 359 354 +665 35 361 359 360 +666 8 363 359 360 +667 8 363 359 361 +668 12 359 360 362 +669 13 359 360 364 +670 13 359 360 365 +671 14 362 360 364 +672 14 362 360 365 +673 15 365 360 364 +674 13 359 361 366 +675 13 359 361 367 +676 13 359 361 368 +677 15 367 361 366 +678 15 368 361 366 +679 15 368 361 367 +680 14 360 362 369 +681 14 360 362 370 +682 14 360 362 371 +683 15 370 362 369 +684 15 371 362 369 +685 15 371 362 370 +686 20 355 372 373 +687 21 355 372 376 +688 22 376 372 373 +689 23 372 373 374 +690 24 372 373 377 +691 25 372 373 378 +692 6 374 373 377 +693 7 374 373 378 +694 8 377 373 378 +695 9 375 374 373 +696 10 387 374 373 +697 11 387 374 375 +698 12 373 378 379 +699 13 373 378 383 +700 13 373 378 384 +701 14 379 378 383 +702 14 379 378 384 +703 15 384 378 383 +704 59 378 379 380 +705 14 378 379 385 +706 14 378 379 386 +707 60 385 379 380 +708 60 386 379 380 +709 15 386 379 385 +710 61 379 380 381 +711 61 379 380 382 +712 62 382 380 381 +713 20 374 387 388 +714 21 374 387 391 +715 22 391 387 388 +716 23 387 388 389 +717 24 387 388 392 +718 25 387 388 393 +719 6 389 388 392 +720 7 389 388 393 +721 8 392 388 393 +722 9 390 389 388 +723 10 401 389 388 +724 11 401 389 390 +725 86 394 393 388 +726 13 388 393 397 +727 13 388 393 398 +728 27 394 393 397 +729 27 394 393 398 +730 15 398 393 397 +731 28 395 394 393 +732 29 396 394 393 +733 11 396 394 395 +734 21 394 396 399 +735 21 394 396 400 +736 30 400 396 399 +737 20 389 401 402 +738 21 389 401 405 +739 22 405 401 402 +740 23 401 402 403 +741 24 401 402 406 +742 31 401 402 407 +743 6 403 402 406 +744 32 403 402 407 +745 33 406 402 407 +746 9 404 403 402 +747 10 417 403 402 +748 11 417 403 404 +749 34 402 407 408 +750 34 402 407 409 +751 33 410 407 402 +752 35 409 407 408 +753 8 410 407 408 +754 8 410 407 409 +755 13 407 408 411 +756 13 407 408 412 +757 13 407 408 413 +758 15 412 408 411 +759 15 413 408 411 +760 15 413 408 412 +761 13 407 409 414 +762 13 407 409 415 +763 13 407 409 416 +764 15 415 409 414 +765 15 416 409 414 +766 15 416 409 415 +767 20 403 417 418 +768 21 403 417 421 +769 22 421 417 418 +770 23 417 418 419 +771 24 417 418 422 +772 25 417 418 423 +773 6 419 418 422 +774 7 419 418 423 +775 8 422 418 423 +776 9 420 419 418 +777 10 439 419 418 +778 11 439 419 420 +779 12 418 423 424 +780 13 418 423 428 +781 13 418 423 429 +782 14 424 423 428 +783 14 424 423 429 +784 15 429 423 428 +785 41 425 424 423 +786 14 423 424 430 +787 14 423 424 431 +788 14 425 424 430 +789 14 425 424 431 +790 15 431 424 430 +791 41 426 425 424 +792 14 424 425 432 +793 14 424 425 433 +794 14 426 425 432 +795 14 426 425 433 +796 15 433 425 432 +797 42 425 426 427 +798 14 425 426 434 +799 14 425 426 435 +800 43 434 426 427 +801 43 435 426 427 +802 15 435 426 434 +803 44 426 427 436 +804 44 426 427 437 +805 44 426 427 438 +806 45 437 427 436 +807 45 438 427 436 +808 45 438 427 437 +809 20 419 439 440 +810 21 419 439 443 +811 22 443 439 440 +812 23 439 440 441 +813 24 439 440 444 +814 25 439 440 445 +815 6 441 440 444 +816 7 441 440 445 +817 8 444 440 445 +818 9 442 441 440 +819 10 449 441 440 +820 11 449 441 442 +821 13 440 445 446 +822 13 440 445 447 +823 13 440 445 448 +824 15 447 445 446 +825 15 448 445 446 +826 15 448 445 447 +827 20 441 449 450 +828 21 441 449 453 +829 22 453 449 450 +830 23 449 450 451 +831 24 449 450 454 +832 25 449 450 455 +833 6 451 450 454 +834 7 451 450 455 +835 8 454 450 455 +836 9 452 451 450 +837 10 471 451 450 +838 11 471 451 452 +839 12 450 455 456 +840 13 450 455 460 +841 13 450 455 461 +842 14 456 455 460 +843 14 456 455 461 +844 15 461 455 460 +845 41 457 456 455 +846 14 455 456 462 +847 14 455 456 463 +848 14 457 456 462 +849 14 457 456 463 +850 15 463 456 462 +851 41 458 457 456 +852 14 456 457 464 +853 14 456 457 465 +854 14 458 457 464 +855 14 458 457 465 +856 15 465 457 464 +857 42 457 458 459 +858 14 457 458 466 +859 14 457 458 467 +860 43 466 458 459 +861 43 467 458 459 +862 15 467 458 466 +863 44 458 459 468 +864 44 458 459 469 +865 44 458 459 470 +866 45 469 459 468 +867 45 470 459 468 +868 45 470 459 469 +869 20 451 471 472 +870 21 451 471 475 +871 22 475 471 472 +872 23 471 472 473 +873 24 471 472 476 +874 31 471 472 477 +875 6 473 472 476 +876 32 473 472 477 +877 33 476 472 477 +878 9 474 473 472 +879 10 490 473 472 +880 11 490 473 474 +881 34 472 477 478 +882 34 472 477 479 +883 33 481 477 472 +884 35 479 477 478 +885 8 481 477 478 +886 8 481 477 479 +887 12 477 478 480 +888 13 477 478 482 +889 13 477 478 483 +890 14 480 478 482 +891 14 480 478 483 +892 15 483 478 482 +893 13 477 479 484 +894 13 477 479 485 +895 13 477 479 486 +896 15 485 479 484 +897 15 486 479 484 +898 15 486 479 485 +899 14 478 480 487 +900 14 478 480 488 +901 14 478 480 489 +902 15 488 480 487 +903 15 489 480 487 +904 15 489 480 488 +905 20 473 490 491 +906 21 473 490 494 +907 22 494 490 491 +908 23 490 491 492 +909 24 490 491 495 +910 25 490 491 496 +911 6 492 491 495 +912 7 492 491 496 +913 8 495 491 496 +914 9 493 492 491 +915 10 507 492 491 +916 11 507 492 493 +917 12 491 496 497 +918 13 491 496 501 +919 13 491 496 502 +920 14 497 496 501 +921 14 497 496 502 +922 15 502 496 501 +923 26 498 497 496 +924 14 496 497 503 +925 14 496 497 504 +926 27 498 497 503 +927 27 498 497 504 +928 15 504 497 503 +929 28 499 498 497 +930 29 500 498 497 +931 11 500 498 499 +932 21 498 500 505 +933 21 498 500 506 +934 30 506 500 505 +935 20 492 507 508 +936 21 492 507 511 +937 22 511 507 508 +938 23 507 508 509 +939 24 507 508 512 +940 25 507 508 513 +941 6 509 508 512 +942 7 509 508 513 +943 8 512 508 513 +944 9 510 509 508 +945 10 519 509 508 +946 11 519 509 510 +947 85 508 513 514 +948 13 508 513 517 +949 13 508 513 518 +950 60 517 513 514 +951 60 518 513 514 +952 15 518 513 517 +953 61 513 514 515 +954 61 513 514 516 +955 62 516 514 515 +956 20 509 519 520 +957 21 509 519 523 +958 22 523 519 520 +959 23 519 520 521 +960 24 519 520 524 +961 25 519 520 525 +962 6 521 520 524 +963 7 521 520 525 +964 8 524 520 525 +965 9 522 521 520 +966 10 541 521 520 +967 11 541 521 522 +968 12 520 525 526 +969 13 520 525 530 +970 13 520 525 531 +971 14 526 525 530 +972 14 526 525 531 +973 15 531 525 530 +974 41 527 526 525 +975 14 525 526 532 +976 14 525 526 533 +977 14 527 526 532 +978 14 527 526 533 +979 15 533 526 532 +980 41 528 527 526 +981 14 526 527 534 +982 14 526 527 535 +983 14 528 527 534 +984 14 528 527 535 +985 15 535 527 534 +986 42 527 528 529 +987 14 527 528 536 +988 14 527 528 537 +989 43 536 528 529 +990 43 537 528 529 +991 15 537 528 536 +992 44 528 529 538 +993 44 528 529 539 +994 44 528 529 540 +995 45 539 529 538 +996 45 540 529 538 +997 45 540 529 539 +998 20 521 541 542 +999 21 521 541 545 +1000 22 545 541 542 +1001 23 541 542 543 +1002 24 541 542 546 +1003 25 541 542 547 +1004 6 543 542 546 +1005 7 543 542 547 +1006 8 546 542 547 +1007 9 544 543 542 +1008 10 556 543 542 +1009 11 556 543 544 +1010 12 542 547 548 +1011 13 542 547 552 +1012 13 542 547 553 +1013 14 548 547 552 +1014 14 548 547 553 +1015 15 553 547 552 +1016 59 547 548 549 +1017 14 547 548 554 +1018 14 547 548 555 +1019 60 554 548 549 +1020 60 555 548 549 +1021 15 555 548 554 +1022 61 548 549 550 +1023 61 548 549 551 +1024 62 551 549 550 +1025 51 557 556 543 +1026 21 543 556 560 +1027 52 557 556 560 +1028 53 556 557 558 +1029 54 556 557 561 +1030 54 556 557 562 +1031 55 558 557 561 +1032 55 558 557 562 +1033 56 562 557 561 +1034 57 557 558 559 +1035 58 563 558 557 +1036 11 563 558 559 +1037 20 558 563 564 +1038 21 558 563 567 +1039 22 567 563 564 +1040 23 563 564 565 +1041 24 563 564 568 +1042 31 563 564 569 +1043 6 565 564 568 +1044 32 565 564 569 +1045 33 568 564 569 +1046 9 566 565 564 +1047 63 564 565 582 +1048 64 566 565 582 +1049 34 564 569 570 +1050 34 564 569 571 +1051 33 573 569 564 +1052 35 571 569 570 +1053 8 573 569 570 +1054 8 573 569 571 +1055 12 569 570 572 +1056 13 569 570 574 +1057 13 569 570 575 +1058 14 572 570 574 +1059 14 572 570 575 +1060 15 575 570 574 +1061 13 569 571 576 +1062 13 569 571 577 +1063 13 569 571 578 +1064 15 577 571 576 +1065 15 578 571 576 +1066 15 578 571 577 +1067 14 570 572 579 +1068 14 570 572 580 +1069 14 570 572 581 +1070 15 580 572 579 +1071 15 581 572 579 +1072 15 581 572 580 +1073 65 565 582 583 +1074 66 565 582 589 +1075 67 583 582 589 +1076 68 584 583 582 +1077 69 586 583 582 +1078 70 582 583 587 +1079 6 584 583 586 +1080 71 584 583 587 +1081 72 586 583 587 +1082 9 585 584 583 +1083 63 583 584 596 +1084 64 585 584 596 +1085 73 583 587 588 +1086 74 583 587 590 +1087 74 583 587 591 +1088 75 590 587 588 +1089 75 591 587 588 +1090 76 591 587 590 +1091 77 589 588 587 +1092 75 592 588 587 +1093 75 593 588 587 +1094 75 592 588 589 +1095 75 593 588 589 +1096 76 593 588 592 +1097 78 582 589 588 +1098 79 594 589 582 +1099 79 595 589 582 +1100 80 594 589 588 +1101 80 595 589 588 +1102 81 595 589 594 +1103 65 584 596 597 +1104 66 584 596 603 +1105 67 597 596 603 +1106 68 598 597 596 +1107 69 600 597 596 +1108 70 596 597 601 +1109 6 598 597 600 +1110 71 598 597 601 +1111 72 600 597 601 +1112 9 599 598 597 +1113 10 610 598 597 +1114 11 610 598 599 +1115 73 597 601 602 +1116 74 597 601 604 +1117 74 597 601 605 +1118 75 604 601 602 +1119 75 605 601 602 +1120 76 605 601 604 +1121 77 603 602 601 +1122 75 606 602 601 +1123 75 607 602 601 +1124 75 606 602 603 +1125 75 607 602 603 +1126 76 607 602 606 +1127 78 596 603 602 +1128 79 608 603 596 +1129 79 609 603 596 +1130 80 608 603 602 +1131 80 609 603 602 +1132 81 609 603 608 +1133 20 598 610 611 +1134 21 598 610 614 +1135 22 614 610 611 +1136 23 610 611 612 +1137 24 610 611 615 +1138 25 610 611 616 +1139 6 612 611 615 +1140 7 612 611 616 +1141 8 615 611 616 +1142 9 613 612 611 +1143 10 622 612 611 +1144 11 622 612 613 +1145 85 611 616 617 +1146 13 611 616 620 +1147 13 611 616 621 +1148 60 620 616 617 +1149 60 621 616 617 +1150 15 621 616 620 +1151 61 616 617 618 +1152 61 616 617 619 +1153 62 619 617 618 +1154 20 612 622 623 +1155 21 612 622 626 +1156 22 626 622 623 +1157 23 622 623 624 +1158 24 622 623 627 +1159 25 622 623 628 +1160 6 624 623 627 +1161 7 624 623 628 +1162 8 627 623 628 +1163 9 625 624 623 +1164 10 639 624 623 +1165 11 639 624 625 +1166 12 623 628 629 +1167 13 623 628 633 +1168 13 623 628 634 +1169 14 629 628 633 +1170 14 629 628 634 +1171 15 634 628 633 +1172 26 630 629 628 +1173 14 628 629 635 +1174 14 628 629 636 +1175 27 630 629 635 +1176 27 630 629 636 +1177 15 636 629 635 +1178 28 631 630 629 +1179 29 632 630 629 +1180 11 632 630 631 +1181 21 630 632 637 +1182 21 630 632 638 +1183 30 638 632 637 +1184 20 624 639 640 +1185 21 624 639 643 +1186 22 643 639 640 +1187 23 639 640 641 +1188 24 639 640 644 +1189 25 639 640 645 +1190 6 641 640 644 +1191 7 641 640 645 +1192 8 644 640 645 +1193 9 642 641 640 +1194 10 656 641 640 +1195 11 656 641 642 +1196 12 640 645 646 +1197 13 640 645 650 +1198 13 640 645 651 +1199 14 646 645 650 +1200 14 646 645 651 +1201 15 651 645 650 +1202 26 647 646 645 +1203 14 645 646 652 +1204 14 645 646 653 +1205 27 647 646 652 +1206 27 647 646 653 +1207 15 653 646 652 +1208 28 648 647 646 +1209 29 649 647 646 +1210 11 649 647 648 +1211 21 647 649 654 +1212 21 647 649 655 +1213 30 655 649 654 +1214 20 641 656 657 +1215 21 641 656 660 +1216 22 660 656 657 +1217 23 656 657 658 +1218 24 656 657 661 +1219 25 656 657 662 +1220 6 658 657 661 +1221 7 658 657 662 +1222 8 661 657 662 +1223 9 659 658 657 +1224 10 680 658 657 +1225 11 680 658 659 +1226 12 657 662 663 +1227 13 657 662 669 +1228 13 657 662 670 +1229 14 663 662 669 +1230 14 663 662 670 +1231 15 670 662 669 +1232 41 664 663 662 +1233 14 662 663 671 +1234 14 662 663 672 +1235 14 664 663 671 +1236 14 664 663 672 +1237 15 672 663 671 +1238 87 665 664 663 +1239 14 663 664 673 +1240 14 663 664 674 +1241 88 665 664 673 +1242 88 665 664 674 +1243 15 674 664 673 +1244 89 664 665 666 +1245 90 664 665 675 +1246 91 675 665 666 +1247 92 667 666 665 +1248 92 668 666 665 +1249 92 668 666 667 +1250 91 676 667 666 +1251 91 677 667 666 +1252 93 677 667 676 +1253 91 678 668 666 +1254 91 679 668 666 +1255 93 679 668 678 +1256 20 658 680 681 +1257 21 658 680 684 +1258 22 684 680 681 +1259 23 680 681 682 +1260 24 680 681 685 +1261 25 680 681 686 +1262 6 682 681 685 +1263 7 682 681 686 +1264 8 685 681 686 +1265 9 683 682 681 +1266 10 699 682 681 +1267 11 699 682 683 +1268 50 687 686 681 +1269 13 681 686 690 +1270 13 681 686 691 +1271 13 687 686 690 +1272 13 687 686 691 +1273 15 691 686 690 +1274 35 688 687 686 +1275 35 689 687 686 +1276 8 692 687 686 +1277 35 689 687 688 +1278 8 692 687 688 +1279 8 692 687 689 +1280 13 687 688 693 +1281 13 687 688 694 +1282 13 687 688 695 +1283 15 694 688 693 +1284 15 695 688 693 +1285 15 695 688 694 +1286 13 687 689 696 +1287 13 687 689 697 +1288 13 687 689 698 +1289 15 697 689 696 +1290 15 698 689 696 +1291 15 698 689 697 +1292 20 682 699 700 +1293 21 682 699 703 +1294 22 703 699 700 +1295 23 699 700 701 +1296 24 699 700 704 +1297 31 699 700 705 +1298 6 701 700 704 +1299 32 701 700 705 +1300 33 704 700 705 +1301 9 702 701 700 +1302 10 718 701 700 +1303 11 718 701 702 +1304 34 700 705 706 +1305 34 700 705 707 +1306 33 709 705 700 +1307 35 707 705 706 +1308 8 709 705 706 +1309 8 709 705 707 +1310 12 705 706 708 +1311 13 705 706 710 +1312 13 705 706 711 +1313 14 708 706 710 +1314 14 708 706 711 +1315 15 711 706 710 +1316 13 705 707 712 +1317 13 705 707 713 +1318 13 705 707 714 +1319 15 713 707 712 +1320 15 714 707 712 +1321 15 714 707 713 +1322 14 706 708 715 +1323 14 706 708 716 +1324 14 706 708 717 +1325 15 716 708 715 +1326 15 717 708 715 +1327 15 717 708 716 +1328 20 701 718 719 +1329 21 701 718 722 +1330 22 722 718 719 +1331 23 718 719 720 +1332 24 718 719 723 +1333 25 718 719 724 +1334 6 720 719 723 +1335 7 720 719 724 +1336 8 723 719 724 +1337 9 721 720 719 +1338 10 738 720 719 +1339 11 738 720 721 +1340 36 719 724 725 +1341 13 719 724 731 +1342 13 719 724 732 +1343 37 731 724 725 +1344 37 732 724 725 +1345 15 732 724 731 +1346 38 724 725 726 +1347 38 724 725 727 +1348 39 727 725 726 +1349 39 728 726 725 +1350 40 725 726 733 +1351 40 728 726 733 +1352 39 729 727 725 +1353 40 725 727 734 +1354 40 729 727 734 +1355 39 730 728 726 +1356 40 726 728 735 +1357 40 730 728 735 +1358 39 730 729 727 +1359 40 727 729 736 +1360 40 730 729 736 +1361 39 729 730 728 +1362 40 728 730 737 +1363 40 729 730 737 +1364 20 720 738 739 +1365 21 720 738 742 +1366 22 742 738 739 +1367 23 738 739 740 +1368 24 738 739 743 +1369 25 738 739 744 +1370 6 740 739 743 +1371 7 740 739 744 +1372 8 743 739 744 +1373 9 741 740 739 +1374 10 748 740 739 +1375 11 748 740 741 +1376 13 739 744 745 +1377 13 739 744 746 +1378 13 739 744 747 +1379 15 746 744 745 +1380 15 747 744 745 +1381 15 747 744 746 +1382 51 749 748 740 +1383 21 740 748 752 +1384 52 749 748 752 +1385 53 748 749 750 +1386 54 748 749 753 +1387 54 748 749 754 +1388 55 750 749 753 +1389 55 750 749 754 +1390 56 754 749 753 +1391 57 749 750 751 +1392 58 755 750 749 +1393 11 755 750 751 +1394 20 750 755 756 +1395 21 750 755 759 +1396 22 759 755 756 +1397 23 755 756 757 +1398 24 755 756 760 +1399 25 755 756 761 +1400 6 757 756 760 +1401 7 757 756 761 +1402 8 760 756 761 +1403 9 758 757 756 +1404 10 777 757 756 +1405 11 777 757 758 +1406 12 756 761 762 +1407 13 756 761 766 +1408 13 756 761 767 +1409 14 762 761 766 +1410 14 762 761 767 +1411 15 767 761 766 +1412 41 763 762 761 +1413 14 761 762 768 +1414 14 761 762 769 +1415 14 763 762 768 +1416 14 763 762 769 +1417 15 769 762 768 +1418 41 764 763 762 +1419 14 762 763 770 +1420 14 762 763 771 +1421 14 764 763 770 +1422 14 764 763 771 +1423 15 771 763 770 +1424 42 763 764 765 +1425 14 763 764 772 +1426 14 763 764 773 +1427 43 772 764 765 +1428 43 773 764 765 +1429 15 773 764 772 +1430 44 764 765 774 +1431 44 764 765 775 +1432 44 764 765 776 +1433 45 775 765 774 +1434 45 776 765 774 +1435 45 776 765 775 +1436 20 757 777 778 +1437 21 757 777 781 +1438 22 781 777 778 +1439 23 777 778 779 +1440 24 777 778 782 +1441 25 777 778 783 +1442 6 779 778 782 +1443 7 779 778 783 +1444 8 782 778 783 +1445 9 780 779 778 +1446 10 794 779 778 +1447 11 794 779 780 +1448 12 778 783 784 +1449 13 778 783 788 +1450 13 778 783 789 +1451 14 784 783 788 +1452 14 784 783 789 +1453 15 789 783 788 +1454 26 785 784 783 +1455 14 783 784 790 +1456 14 783 784 791 +1457 27 785 784 790 +1458 27 785 784 791 +1459 15 791 784 790 +1460 28 786 785 784 +1461 29 787 785 784 +1462 11 787 785 786 +1463 21 785 787 792 +1464 21 785 787 793 +1465 30 793 787 792 +1466 20 779 794 795 +1467 21 779 794 798 +1468 22 798 794 795 +1469 23 794 795 796 +1470 24 794 795 799 +1471 25 794 795 800 +1472 6 796 795 799 +1473 7 796 795 800 +1474 8 799 795 800 +1475 9 797 796 795 +1476 10 813 796 795 +1477 11 813 796 797 +1478 50 801 800 795 +1479 13 795 800 804 +1480 13 795 800 805 +1481 13 801 800 804 +1482 13 801 800 805 +1483 15 805 800 804 +1484 35 802 801 800 +1485 35 803 801 800 +1486 8 806 801 800 +1487 35 803 801 802 +1488 8 806 801 802 +1489 8 806 801 803 +1490 13 801 802 807 +1491 13 801 802 808 +1492 13 801 802 809 +1493 15 808 802 807 +1494 15 809 802 807 +1495 15 809 802 808 +1496 13 801 803 810 +1497 13 801 803 811 +1498 13 801 803 812 +1499 15 811 803 810 +1500 15 812 803 810 +1501 15 812 803 811 +1502 20 796 813 814 +1503 21 796 813 817 +1504 22 817 813 814 +1505 23 813 814 815 +1506 24 813 814 818 +1507 25 813 814 819 +1508 6 815 814 818 +1509 7 815 814 819 +1510 8 818 814 819 +1511 9 816 815 814 +1512 10 828 815 814 +1513 11 828 815 816 +1514 12 814 819 820 +1515 13 814 819 824 +1516 13 814 819 825 +1517 14 820 819 824 +1518 14 820 819 825 +1519 15 825 819 824 +1520 59 819 820 821 +1521 14 819 820 826 +1522 14 819 820 827 +1523 60 826 820 821 +1524 60 827 820 821 +1525 15 827 820 826 +1526 61 820 821 822 +1527 61 820 821 823 +1528 62 823 821 822 +1529 20 815 828 829 +1530 21 815 828 832 +1531 22 832 828 829 +1532 23 828 829 830 +1533 24 828 829 833 +1534 25 828 829 834 +1535 6 830 829 833 +1536 7 830 829 834 +1537 8 833 829 834 +1538 9 831 830 829 +1539 10 840 830 829 +1540 11 840 830 831 +1541 85 829 834 835 +1542 13 829 834 838 +1543 13 829 834 839 +1544 60 838 834 835 +1545 60 839 834 835 +1546 15 839 834 838 +1547 61 834 835 836 +1548 61 834 835 837 +1549 62 837 835 836 +1550 51 841 840 830 +1551 21 830 840 844 +1552 52 841 840 844 +1553 53 840 841 842 +1554 54 840 841 845 +1555 54 840 841 846 +1556 55 842 841 845 +1557 55 842 841 846 +1558 56 846 841 845 +1559 57 841 842 843 +1560 58 847 842 841 +1561 11 847 842 843 +1562 20 842 847 848 +1563 21 842 847 851 +1564 22 851 847 848 +1565 23 847 848 849 +1566 24 847 848 852 +1567 25 847 848 853 +1568 6 849 848 852 +1569 7 849 848 853 +1570 8 852 848 853 +1571 9 850 849 848 +1572 10 871 849 848 +1573 11 871 849 850 +1574 12 848 853 854 +1575 13 848 853 860 +1576 13 848 853 861 +1577 14 854 853 860 +1578 14 854 853 861 +1579 15 861 853 860 +1580 41 855 854 853 +1581 14 853 854 862 +1582 14 853 854 863 +1583 14 855 854 862 +1584 14 855 854 863 +1585 15 863 854 862 +1586 87 856 855 854 +1587 14 854 855 864 +1588 14 854 855 865 +1589 88 856 855 864 +1590 88 856 855 865 +1591 15 865 855 864 +1592 89 855 856 857 +1593 90 855 856 866 +1594 91 866 856 857 +1595 92 858 857 856 +1596 92 859 857 856 +1597 92 859 857 858 +1598 91 867 858 857 +1599 91 868 858 857 +1600 93 868 858 867 +1601 91 869 859 857 +1602 91 870 859 857 +1603 93 870 859 869 +1604 20 849 871 872 +1605 21 849 871 875 +1606 22 875 871 872 +1607 23 871 872 873 +1608 24 871 872 876 +1609 31 871 872 877 +1610 6 873 872 876 +1611 32 873 872 877 +1612 33 876 872 877 +1613 9 874 873 872 +1614 10 885 873 872 +1615 11 885 873 874 +1616 46 872 877 878 +1617 34 872 877 879 +1618 33 880 877 872 +1619 47 879 877 878 +1620 48 880 877 878 +1621 8 880 877 879 +1622 49 877 878 881 +1623 13 877 879 882 +1624 13 877 879 883 +1625 13 877 879 884 +1626 15 883 879 882 +1627 15 884 879 882 +1628 15 884 879 883 +1629 20 873 885 886 +1630 21 873 885 889 +1631 22 889 885 886 +1632 23 885 886 887 +1633 24 885 886 890 +1634 25 885 886 891 +1635 6 887 886 890 +1636 7 887 886 891 +1637 8 890 886 891 +1638 9 888 887 886 +1639 10 904 887 886 +1640 11 904 887 888 +1641 50 892 891 886 +1642 13 886 891 895 +1643 13 886 891 896 +1644 13 892 891 895 +1645 13 892 891 896 +1646 15 896 891 895 +1647 35 893 892 891 +1648 35 894 892 891 +1649 8 897 892 891 +1650 35 894 892 893 +1651 8 897 892 893 +1652 8 897 892 894 +1653 13 892 893 898 +1654 13 892 893 899 +1655 13 892 893 900 +1656 15 899 893 898 +1657 15 900 893 898 +1658 15 900 893 899 +1659 13 892 894 901 +1660 13 892 894 902 +1661 13 892 894 903 +1662 15 902 894 901 +1663 15 903 894 901 +1664 15 903 894 902 +1665 20 887 904 905 +1666 21 887 904 908 +1667 22 908 904 905 +1668 23 904 905 906 +1669 24 904 905 909 +1670 25 904 905 910 +1671 6 906 905 909 +1672 7 906 905 910 +1673 8 909 905 910 +1674 9 907 906 905 +1675 10 915 906 905 +1676 11 915 906 907 +1677 82 905 910 911 +1678 13 905 910 912 +1679 13 905 910 913 +1680 83 912 910 911 +1681 83 913 910 911 +1682 15 913 910 912 +1683 84 910 911 914 +1684 20 906 915 916 +1685 21 906 915 919 +1686 22 919 915 916 +1687 23 915 916 917 +1688 24 915 916 920 +1689 25 915 916 921 +1690 6 917 916 920 +1691 7 917 916 921 +1692 8 920 916 921 +1693 9 918 917 916 +1694 10 927 917 916 +1695 11 927 917 918 +1696 85 916 921 922 +1697 13 916 921 925 +1698 13 916 921 926 +1699 60 925 921 922 +1700 60 926 921 922 +1701 15 926 921 925 +1702 61 921 922 923 +1703 61 921 922 924 +1704 62 924 922 923 +1705 20 917 927 928 +1706 21 917 927 931 +1707 22 931 927 928 +1708 23 927 928 929 +1709 24 927 928 932 +1710 25 927 928 933 +1711 6 929 928 932 +1712 7 929 928 933 +1713 8 932 928 933 +1714 9 930 929 928 +1715 10 948 929 928 +1716 11 948 929 930 +1717 36 928 933 934 +1718 13 928 933 941 +1719 13 928 933 942 +1720 37 941 933 934 +1721 37 942 933 934 +1722 15 942 933 941 +1723 38 933 934 935 +1724 38 933 934 936 +1725 39 936 934 935 +1726 39 937 935 934 +1727 40 934 935 943 +1728 40 937 935 943 +1729 39 938 936 934 +1730 40 934 936 944 +1731 40 938 936 944 +1732 39 939 937 935 +1733 40 935 937 945 +1734 40 939 937 945 +1735 39 939 938 936 +1736 40 936 938 946 +1737 40 939 938 946 +1738 39 938 939 937 +1739 94 937 939 940 +1740 94 938 939 940 +1741 95 939 940 947 +1742 20 929 948 949 +1743 21 929 948 952 +1744 22 952 948 949 +1745 23 948 949 950 +1746 24 948 949 953 +1747 25 948 949 954 +1748 6 950 949 953 +1749 7 950 949 954 +1750 8 953 949 954 +1751 9 951 950 949 +1752 10 962 950 949 +1753 11 962 950 951 +1754 86 955 954 949 +1755 13 949 954 958 +1756 13 949 954 959 +1757 27 955 954 958 +1758 27 955 954 959 +1759 15 959 954 958 +1760 28 956 955 954 +1761 29 957 955 954 +1762 11 957 955 956 +1763 21 955 957 960 +1764 21 955 957 961 +1765 30 961 957 960 +1766 20 950 962 963 +1767 21 950 962 966 +1768 22 966 962 963 +1769 23 962 963 964 +1770 24 962 963 967 +1771 31 962 963 968 +1772 6 964 963 967 +1773 32 964 963 968 +1774 33 967 963 968 +1775 9 965 964 963 +1776 10 981 964 963 +1777 11 981 964 965 +1778 34 963 968 969 +1779 34 963 968 970 +1780 33 972 968 963 +1781 35 970 968 969 +1782 8 972 968 969 +1783 8 972 968 970 +1784 12 968 969 971 +1785 13 968 969 973 +1786 13 968 969 974 +1787 14 971 969 973 +1788 14 971 969 974 +1789 15 974 969 973 +1790 13 968 970 975 +1791 13 968 970 976 +1792 13 968 970 977 +1793 15 976 970 975 +1794 15 977 970 975 +1795 15 977 970 976 +1796 14 969 971 978 +1797 14 969 971 979 +1798 14 969 971 980 +1799 15 979 971 978 +1800 15 980 971 978 +1801 15 980 971 979 +1802 20 964 981 982 +1803 21 964 981 985 +1804 22 985 981 982 +1805 23 981 982 983 +1806 24 981 982 986 +1807 25 981 982 987 +1808 6 983 982 986 +1809 7 983 982 987 +1810 8 986 982 987 +1811 9 984 983 982 +1812 10 998 983 982 +1813 11 998 983 984 +1814 12 982 987 988 +1815 13 982 987 992 +1816 13 982 987 993 +1817 14 988 987 992 +1818 14 988 987 993 +1819 15 993 987 992 +1820 26 989 988 987 +1821 14 987 988 994 +1822 14 987 988 995 +1823 27 989 988 994 +1824 27 989 988 995 +1825 15 995 988 994 +1826 28 990 989 988 +1827 29 991 989 988 +1828 11 991 989 990 +1829 21 989 991 996 +1830 21 989 991 997 +1831 30 997 991 996 +1832 20 983 998 999 +1833 21 983 998 1002 +1834 22 1002 998 999 +1835 23 998 999 1000 +1836 24 998 999 1003 +1837 25 998 999 1004 +1838 6 1000 999 1003 +1839 7 1000 999 1004 +1840 8 1003 999 1004 +1841 9 1001 1000 999 +1842 10 1020 1000 999 +1843 11 1020 1000 1001 +1844 12 999 1004 1005 +1845 13 999 1004 1009 +1846 13 999 1004 1010 +1847 14 1005 1004 1009 +1848 14 1005 1004 1010 +1849 15 1010 1004 1009 +1850 41 1006 1005 1004 +1851 14 1004 1005 1011 +1852 14 1004 1005 1012 +1853 14 1006 1005 1011 +1854 14 1006 1005 1012 +1855 15 1012 1005 1011 +1856 41 1007 1006 1005 +1857 14 1005 1006 1013 +1858 14 1005 1006 1014 +1859 14 1007 1006 1013 +1860 14 1007 1006 1014 +1861 15 1014 1006 1013 +1862 42 1006 1007 1008 +1863 14 1006 1007 1015 +1864 14 1006 1007 1016 +1865 43 1015 1007 1008 +1866 43 1016 1007 1008 +1867 15 1016 1007 1015 +1868 44 1007 1008 1017 +1869 44 1007 1008 1018 +1870 44 1007 1008 1019 +1871 45 1018 1008 1017 +1872 45 1019 1008 1017 +1873 45 1019 1008 1018 +1874 20 1000 1020 1021 +1875 21 1000 1020 1024 +1876 22 1024 1020 1021 +1877 23 1020 1021 1022 +1878 24 1020 1021 1025 +1879 25 1020 1021 1026 +1880 6 1022 1021 1025 +1881 7 1022 1021 1026 +1882 8 1025 1021 1026 +1883 9 1023 1022 1021 +1884 10 1035 1022 1021 +1885 11 1035 1022 1023 +1886 12 1021 1026 1027 +1887 13 1021 1026 1031 +1888 13 1021 1026 1032 +1889 14 1027 1026 1031 +1890 14 1027 1026 1032 +1891 15 1032 1026 1031 +1892 59 1026 1027 1028 +1893 14 1026 1027 1033 +1894 14 1026 1027 1034 +1895 60 1033 1027 1028 +1896 60 1034 1027 1028 +1897 15 1034 1027 1033 +1898 61 1027 1028 1029 +1899 61 1027 1028 1030 +1900 62 1030 1028 1029 +1901 20 1022 1035 1036 +1902 21 1022 1035 1039 +1903 22 1039 1035 1036 +1904 23 1035 1036 1037 +1905 24 1035 1036 1040 +1906 25 1035 1036 1041 +1907 6 1037 1036 1040 +1908 7 1037 1036 1041 +1909 8 1040 1036 1041 +1910 9 1038 1037 1036 +1911 10 1046 1037 1036 +1912 11 1046 1037 1038 +1913 82 1036 1041 1042 +1914 13 1036 1041 1043 +1915 13 1036 1041 1044 +1916 83 1043 1041 1042 +1917 83 1044 1041 1042 +1918 15 1044 1041 1043 +1919 84 1041 1042 1045 +1920 20 1037 1046 1047 +1921 21 1037 1046 1050 +1922 22 1050 1046 1047 +1923 23 1046 1047 1048 +1924 24 1046 1047 1051 +1925 31 1046 1047 1052 +1926 6 1048 1047 1051 +1927 32 1048 1047 1052 +1928 33 1051 1047 1052 +1929 9 1049 1048 1047 +1930 10 1060 1048 1047 +1931 11 1060 1048 1049 +1932 46 1047 1052 1053 +1933 34 1047 1052 1054 +1934 33 1055 1052 1047 +1935 47 1054 1052 1053 +1936 48 1055 1052 1053 +1937 8 1055 1052 1054 +1938 49 1052 1053 1056 +1939 13 1052 1054 1057 +1940 13 1052 1054 1058 +1941 13 1052 1054 1059 +1942 15 1058 1054 1057 +1943 15 1059 1054 1057 +1944 15 1059 1054 1058 +1945 20 1048 1060 1061 +1946 21 1048 1060 1064 +1947 22 1064 1060 1061 +1948 23 1060 1061 1062 +1949 24 1060 1061 1065 +1950 25 1060 1061 1066 +1951 6 1062 1061 1065 +1952 7 1062 1061 1066 +1953 8 1065 1061 1066 +1954 9 1063 1062 1061 +1955 10 1079 1062 1061 +1956 11 1079 1062 1063 +1957 50 1067 1066 1061 +1958 13 1061 1066 1070 +1959 13 1061 1066 1071 +1960 13 1067 1066 1070 +1961 13 1067 1066 1071 +1962 15 1071 1066 1070 +1963 35 1068 1067 1066 +1964 35 1069 1067 1066 +1965 8 1072 1067 1066 +1966 35 1069 1067 1068 +1967 8 1072 1067 1068 +1968 8 1072 1067 1069 +1969 13 1067 1068 1073 +1970 13 1067 1068 1074 +1971 13 1067 1068 1075 +1972 15 1074 1068 1073 +1973 15 1075 1068 1073 +1974 15 1075 1068 1074 +1975 13 1067 1069 1076 +1976 13 1067 1069 1077 +1977 13 1067 1069 1078 +1978 15 1077 1069 1076 +1979 15 1078 1069 1076 +1980 15 1078 1069 1077 +1981 20 1062 1079 1080 +1982 21 1062 1079 1083 +1983 22 1083 1079 1080 +1984 23 1079 1080 1081 +1985 24 1079 1080 1084 +1986 25 1079 1080 1085 +1987 6 1081 1080 1084 +1988 7 1081 1080 1085 +1989 8 1084 1080 1085 +1990 9 1082 1081 1080 +1991 10 1097 1081 1080 +1992 11 1097 1081 1082 +1993 96 1080 1085 1086 +1994 13 1080 1085 1091 +1995 13 1080 1085 1092 +1996 97 1091 1085 1086 +1997 97 1092 1085 1086 +1998 15 1092 1085 1091 +1999 98 1085 1086 1087 +2000 99 1085 1086 1088 +2001 100 1087 1086 1088 +2002 101 1086 1087 1089 +2003 102 1093 1087 1086 +2004 103 1093 1087 1089 +2005 100 1090 1088 1086 +2006 104 1086 1088 1094 +2007 105 1090 1088 1094 +2008 106 1090 1089 1087 +2009 107 1087 1089 1095 +2010 107 1090 1089 1095 +2011 101 1088 1090 1089 +2012 102 1096 1090 1088 +2013 103 1096 1090 1089 +2014 20 1081 1097 1098 +2015 21 1081 1097 1101 +2016 22 1101 1097 1098 +2017 23 1097 1098 1099 +2018 24 1097 1098 1102 +2019 25 1097 1098 1103 +2020 6 1099 1098 1102 +2021 7 1099 1098 1103 +2022 8 1102 1098 1103 +2023 9 1100 1099 1098 +2024 10 1116 1099 1098 +2025 11 1116 1099 1100 +2026 50 1104 1103 1098 +2027 13 1098 1103 1107 +2028 13 1098 1103 1108 +2029 13 1104 1103 1107 +2030 13 1104 1103 1108 +2031 15 1108 1103 1107 +2032 35 1105 1104 1103 +2033 35 1106 1104 1103 +2034 8 1109 1104 1103 +2035 35 1106 1104 1105 +2036 8 1109 1104 1105 +2037 8 1109 1104 1106 +2038 13 1104 1105 1110 +2039 13 1104 1105 1111 +2040 13 1104 1105 1112 +2041 15 1111 1105 1110 +2042 15 1112 1105 1110 +2043 15 1112 1105 1111 +2044 13 1104 1106 1113 +2045 13 1104 1106 1114 +2046 13 1104 1106 1115 +2047 15 1114 1106 1113 +2048 15 1115 1106 1113 +2049 15 1115 1106 1114 +2050 20 1099 1116 1117 +2051 21 1099 1116 1120 +2052 22 1120 1116 1117 +2053 23 1116 1117 1118 +2054 24 1116 1117 1121 +2055 31 1116 1117 1122 +2056 6 1118 1117 1121 +2057 32 1118 1117 1122 +2058 33 1121 1117 1122 +2059 9 1119 1118 1117 +2060 10 1132 1118 1117 +2061 11 1132 1118 1119 +2062 34 1117 1122 1123 +2063 34 1117 1122 1124 +2064 33 1125 1122 1117 +2065 35 1124 1122 1123 +2066 8 1125 1122 1123 +2067 8 1125 1122 1124 +2068 13 1122 1123 1126 +2069 13 1122 1123 1127 +2070 13 1122 1123 1128 +2071 15 1127 1123 1126 +2072 15 1128 1123 1126 +2073 15 1128 1123 1127 +2074 13 1122 1124 1129 +2075 13 1122 1124 1130 +2076 13 1122 1124 1131 +2077 15 1130 1124 1129 +2078 15 1131 1124 1129 +2079 15 1131 1124 1130 +2080 20 1118 1132 1133 +2081 21 1118 1132 1136 +2082 22 1136 1132 1133 +2083 23 1132 1133 1134 +2084 24 1132 1133 1137 +2085 25 1132 1133 1138 +2086 6 1134 1133 1137 +2087 7 1134 1133 1138 +2088 8 1137 1133 1138 +2089 9 1135 1134 1133 +2090 10 1151 1134 1133 +2091 11 1151 1134 1135 +2092 50 1139 1138 1133 +2093 13 1133 1138 1142 +2094 13 1133 1138 1143 +2095 13 1139 1138 1142 +2096 13 1139 1138 1143 +2097 15 1143 1138 1142 +2098 35 1140 1139 1138 +2099 35 1141 1139 1138 +2100 8 1144 1139 1138 +2101 35 1141 1139 1140 +2102 8 1144 1139 1140 +2103 8 1144 1139 1141 +2104 13 1139 1140 1145 +2105 13 1139 1140 1146 +2106 13 1139 1140 1147 +2107 15 1146 1140 1145 +2108 15 1147 1140 1145 +2109 15 1147 1140 1146 +2110 13 1139 1141 1148 +2111 13 1139 1141 1149 +2112 13 1139 1141 1150 +2113 15 1149 1141 1148 +2114 15 1150 1141 1148 +2115 15 1150 1141 1149 +2116 20 1134 1151 1152 +2117 21 1134 1151 1155 +2118 22 1155 1151 1152 +2119 23 1151 1152 1153 +2120 24 1151 1152 1156 +2121 25 1151 1152 1157 +2122 6 1153 1152 1156 +2123 7 1153 1152 1157 +2124 8 1156 1152 1157 +2125 9 1154 1153 1152 +2126 10 1175 1153 1152 +2127 11 1175 1153 1154 +2128 12 1152 1157 1158 +2129 13 1152 1157 1164 +2130 13 1152 1157 1165 +2131 14 1158 1157 1164 +2132 14 1158 1157 1165 +2133 15 1165 1157 1164 +2134 41 1159 1158 1157 +2135 14 1157 1158 1166 +2136 14 1157 1158 1167 +2137 14 1159 1158 1166 +2138 14 1159 1158 1167 +2139 15 1167 1158 1166 +2140 87 1160 1159 1158 +2141 14 1158 1159 1168 +2142 14 1158 1159 1169 +2143 88 1160 1159 1168 +2144 88 1160 1159 1169 +2145 15 1169 1159 1168 +2146 89 1159 1160 1161 +2147 90 1159 1160 1170 +2148 91 1170 1160 1161 +2149 92 1162 1161 1160 +2150 92 1163 1161 1160 +2151 92 1163 1161 1162 +2152 91 1171 1162 1161 +2153 91 1172 1162 1161 +2154 93 1172 1162 1171 +2155 91 1173 1163 1161 +2156 91 1174 1163 1161 +2157 93 1174 1163 1173 +2158 20 1153 1175 1176 +2159 21 1153 1175 1179 +2160 22 1179 1175 1176 +2161 23 1175 1176 1177 +2162 24 1175 1176 1180 +2163 25 1175 1176 1181 +2164 6 1177 1176 1180 +2165 7 1177 1176 1181 +2166 8 1180 1176 1181 +2167 9 1178 1177 1176 +2168 10 1194 1177 1176 +2169 11 1194 1177 1178 +2170 50 1182 1181 1176 +2171 13 1176 1181 1185 +2172 13 1176 1181 1186 +2173 13 1182 1181 1185 +2174 13 1182 1181 1186 +2175 15 1186 1181 1185 +2176 35 1183 1182 1181 +2177 35 1184 1182 1181 +2178 8 1187 1182 1181 +2179 35 1184 1182 1183 +2180 8 1187 1182 1183 +2181 8 1187 1182 1184 +2182 13 1182 1183 1188 +2183 13 1182 1183 1189 +2184 13 1182 1183 1190 +2185 15 1189 1183 1188 +2186 15 1190 1183 1188 +2187 15 1190 1183 1189 +2188 13 1182 1184 1191 +2189 13 1182 1184 1192 +2190 13 1182 1184 1193 +2191 15 1192 1184 1191 +2192 15 1193 1184 1191 +2193 15 1193 1184 1192 +2194 20 1177 1194 1195 +2195 21 1177 1194 1198 +2196 22 1198 1194 1195 +2197 23 1194 1195 1196 +2198 24 1194 1195 1199 +2199 25 1194 1195 1200 +2200 6 1196 1195 1199 +2201 7 1196 1195 1200 +2202 8 1199 1195 1200 +2203 9 1197 1196 1195 +2204 10 1218 1196 1195 +2205 11 1218 1196 1197 +2206 12 1195 1200 1201 +2207 13 1195 1200 1207 +2208 13 1195 1200 1208 +2209 14 1201 1200 1207 +2210 14 1201 1200 1208 +2211 15 1208 1200 1207 +2212 41 1202 1201 1200 +2213 14 1200 1201 1209 +2214 14 1200 1201 1210 +2215 14 1202 1201 1209 +2216 14 1202 1201 1210 +2217 15 1210 1201 1209 +2218 87 1203 1202 1201 +2219 14 1201 1202 1211 +2220 14 1201 1202 1212 +2221 88 1203 1202 1211 +2222 88 1203 1202 1212 +2223 15 1212 1202 1211 +2224 89 1202 1203 1204 +2225 90 1202 1203 1213 +2226 91 1213 1203 1204 +2227 92 1205 1204 1203 +2228 92 1206 1204 1203 +2229 92 1206 1204 1205 +2230 91 1214 1205 1204 +2231 91 1215 1205 1204 +2232 93 1215 1205 1214 +2233 91 1216 1206 1204 +2234 91 1217 1206 1204 +2235 93 1217 1206 1216 +2236 51 1219 1218 1196 +2237 21 1196 1218 1222 +2238 52 1219 1218 1222 +2239 53 1218 1219 1220 +2240 54 1218 1219 1223 +2241 54 1218 1219 1224 +2242 55 1220 1219 1223 +2243 55 1220 1219 1224 +2244 56 1224 1219 1223 +2245 57 1219 1220 1221 +2246 58 1225 1220 1219 +2247 11 1225 1220 1221 +2248 51 1226 1225 1220 +2249 21 1220 1225 1229 +2250 52 1226 1225 1229 +2251 108 1225 1226 1227 +2252 54 1225 1226 1230 +2253 54 1225 1226 1231 +2254 109 1230 1226 1227 +2255 109 1231 1226 1227 +2256 56 1231 1226 1230 +2257 110 1226 1227 1228 +2258 110 1226 1227 1232 +2259 62 1232 1227 1228 +2260 111 1235 1233 1234 +2261 111 1238 1236 1237 +2262 111 1241 1239 1240 +2263 111 1244 1242 1243 +2264 111 1247 1245 1246 +2265 111 1250 1248 1249 +2266 111 1253 1251 1252 +2267 111 1256 1254 1255 +2268 111 1259 1257 1258 +2269 111 1262 1260 1261 +2270 111 1265 1263 1264 +2271 111 1268 1266 1267 +2272 111 1271 1269 1270 +2273 111 1274 1272 1273 +2274 111 1277 1275 1276 +2275 111 1280 1278 1279 +2276 111 1283 1281 1282 +2277 111 1286 1284 1285 +2278 111 1289 1287 1288 +2279 111 1292 1290 1291 +2280 111 1295 1293 1294 +2281 111 1298 1296 1297 +2282 111 1301 1299 1300 +2283 111 1304 1302 1303 +2284 111 1307 1305 1306 +2285 111 1310 1308 1309 +2286 111 1313 1311 1312 +2287 111 1316 1314 1315 +2288 111 1319 1317 1318 +2289 111 1322 1320 1321 +2290 111 1325 1323 1324 +2291 111 1328 1326 1327 +2292 111 1331 1329 1330 +2293 111 1334 1332 1333 +2294 111 1337 1335 1336 +2295 111 1340 1338 1339 +2296 111 1343 1341 1342 +2297 111 1346 1344 1345 +2298 111 1349 1347 1348 +2299 111 1352 1350 1351 +2300 111 1355 1353 1354 +2301 111 1358 1356 1357 +2302 111 1361 1359 1360 +2303 111 1364 1362 1363 +2304 111 1367 1365 1366 +2305 111 1370 1368 1369 +2306 111 1373 1371 1372 +2307 111 1376 1374 1375 +2308 111 1379 1377 1378 +2309 111 1382 1380 1381 +2310 111 1385 1383 1384 +2311 111 1388 1386 1387 +2312 111 1391 1389 1390 +2313 111 1394 1392 1393 +2314 111 1397 1395 1396 +2315 111 1400 1398 1399 +2316 111 1403 1401 1402 +2317 111 1406 1404 1405 +2318 111 1409 1407 1408 +2319 111 1412 1410 1411 +2320 111 1415 1413 1414 +2321 111 1418 1416 1417 +2322 111 1421 1419 1420 +2323 111 1424 1422 1423 +2324 111 1427 1425 1426 +2325 111 1430 1428 1429 +2326 111 1433 1431 1432 +2327 111 1436 1434 1435 +2328 111 1439 1437 1438 +2329 111 1442 1440 1441 +2330 111 1445 1443 1444 +2331 111 1448 1446 1447 +2332 111 1451 1449 1450 +2333 111 1454 1452 1453 +2334 111 1457 1455 1456 +2335 111 1460 1458 1459 +2336 111 1463 1461 1462 +2337 111 1466 1464 1465 +2338 111 1469 1467 1468 +2339 111 1472 1470 1471 +2340 111 1475 1473 1474 +2341 111 1478 1476 1477 +2342 111 1481 1479 1480 +2343 111 1484 1482 1483 +2344 111 1487 1485 1486 +2345 111 1490 1488 1489 +2346 111 1493 1491 1492 +2347 111 1496 1494 1495 +2348 111 1499 1497 1498 +2349 111 1502 1500 1501 +2350 111 1505 1503 1504 +2351 111 1508 1506 1507 +2352 111 1511 1509 1510 +2353 111 1514 1512 1513 +2354 111 1517 1515 1516 +2355 111 1520 1518 1519 +2356 111 1523 1521 1522 +2357 111 1526 1524 1525 +2358 111 1529 1527 1528 +2359 111 1532 1530 1531 +2360 111 1535 1533 1534 +2361 111 1538 1536 1537 +2362 111 1541 1539 1540 +2363 111 1544 1542 1543 +2364 111 1547 1545 1546 +2365 111 1550 1548 1549 +2366 111 1553 1551 1552 +2367 111 1556 1554 1555 +2368 111 1559 1557 1558 +2369 111 1562 1560 1561 +2370 111 1565 1563 1564 +2371 111 1568 1566 1567 +2372 111 1571 1569 1570 +2373 111 1574 1572 1573 +2374 111 1577 1575 1576 +2375 111 1580 1578 1579 +2376 111 1583 1581 1582 +2377 111 1586 1584 1585 +2378 111 1589 1587 1588 +2379 111 1592 1590 1591 +2380 111 1595 1593 1594 +2381 111 1598 1596 1597 +2382 111 1601 1599 1600 +2383 111 1604 1602 1603 +2384 111 1607 1605 1606 +2385 111 1610 1608 1609 +2386 111 1613 1611 1612 +2387 111 1616 1614 1615 +2388 111 1619 1617 1618 +2389 111 1622 1620 1621 +2390 111 1625 1623 1624 +2391 111 1628 1626 1627 +2392 111 1631 1629 1630 +2393 111 1634 1632 1633 +2394 111 1637 1635 1636 +2395 111 1640 1638 1639 +2396 111 1643 1641 1642 +2397 111 1646 1644 1645 +2398 111 1649 1647 1648 +2399 111 1652 1650 1651 +2400 111 1655 1653 1654 +2401 111 1658 1656 1657 +2402 111 1661 1659 1660 +2403 111 1664 1662 1663 +2404 111 1667 1665 1666 +2405 111 1670 1668 1669 +2406 111 1673 1671 1672 +2407 111 1676 1674 1675 +2408 111 1679 1677 1678 +2409 111 1682 1680 1681 +2410 111 1685 1683 1684 +2411 111 1688 1686 1687 +2412 111 1691 1689 1690 +2413 111 1694 1692 1693 +2414 111 1697 1695 1696 +2415 111 1700 1698 1699 +2416 111 1703 1701 1702 +2417 111 1706 1704 1705 +2418 111 1709 1707 1708 +2419 111 1712 1710 1711 +2420 111 1715 1713 1714 +2421 111 1718 1716 1717 +2422 111 1721 1719 1720 +2423 111 1724 1722 1723 +2424 111 1727 1725 1726 +2425 111 1730 1728 1729 +2426 111 1733 1731 1732 +2427 111 1736 1734 1735 +2428 111 1739 1737 1738 +2429 111 1742 1740 1741 +2430 111 1745 1743 1744 +2431 111 1748 1746 1747 +2432 111 1751 1749 1750 +2433 111 1754 1752 1753 +2434 111 1757 1755 1756 +2435 111 1760 1758 1759 +2436 111 1763 1761 1762 +2437 111 1766 1764 1765 +2438 111 1769 1767 1768 +2439 111 1772 1770 1771 +2440 111 1775 1773 1774 +2441 111 1778 1776 1777 +2442 111 1781 1779 1780 +2443 111 1784 1782 1783 +2444 111 1787 1785 1786 +2445 111 1790 1788 1789 +2446 111 1793 1791 1792 +2447 111 1796 1794 1795 +2448 111 1799 1797 1798 +2449 111 1802 1800 1801 +2450 111 1805 1803 1804 +2451 111 1808 1806 1807 +2452 111 1811 1809 1810 +2453 111 1814 1812 1813 +2454 111 1817 1815 1816 +2455 111 1820 1818 1819 +2456 111 1823 1821 1822 +2457 111 1826 1824 1825 +2458 111 1829 1827 1828 +2459 111 1832 1830 1831 +2460 111 1835 1833 1834 +2461 111 1838 1836 1837 +2462 111 1841 1839 1840 +2463 111 1844 1842 1843 +2464 111 1847 1845 1846 +2465 111 1850 1848 1849 +2466 111 1853 1851 1852 +2467 111 1856 1854 1855 +2468 111 1859 1857 1858 +2469 111 1862 1860 1861 +2470 111 1865 1863 1864 +2471 111 1868 1866 1867 +2472 111 1871 1869 1870 +2473 111 1874 1872 1873 +2474 111 1877 1875 1876 +2475 111 1880 1878 1879 +2476 111 1883 1881 1882 +2477 111 1886 1884 1885 +2478 111 1889 1887 1888 +2479 111 1892 1890 1891 +2480 111 1895 1893 1894 +2481 111 1898 1896 1897 +2482 111 1901 1899 1900 +2483 111 1904 1902 1903 +2484 111 1907 1905 1906 +2485 111 1910 1908 1909 +2486 111 1913 1911 1912 +2487 111 1916 1914 1915 +2488 111 1919 1917 1918 +2489 111 1922 1920 1921 +2490 111 1925 1923 1924 +2491 111 1928 1926 1927 +2492 111 1931 1929 1930 +2493 111 1934 1932 1933 +2494 111 1937 1935 1936 +2495 111 1940 1938 1939 +2496 111 1943 1941 1942 +2497 111 1946 1944 1945 +2498 111 1949 1947 1948 +2499 111 1952 1950 1951 +2500 111 1955 1953 1954 +2501 111 1958 1956 1957 +2502 111 1961 1959 1960 +2503 111 1964 1962 1963 +2504 111 1967 1965 1966 +2505 111 1970 1968 1969 +2506 111 1973 1971 1972 +2507 111 1976 1974 1975 +2508 111 1979 1977 1978 +2509 111 1982 1980 1981 +2510 111 1985 1983 1984 +2511 111 1988 1986 1987 +2512 111 1991 1989 1990 +2513 111 1994 1992 1993 +2514 111 1997 1995 1996 +2515 111 2000 1998 1999 +2516 111 2003 2001 2002 +2517 111 2006 2004 2005 +2518 111 2009 2007 2008 +2519 111 2012 2010 2011 +2520 111 2015 2013 2014 +2521 111 2018 2016 2017 +2522 111 2021 2019 2020 +2523 111 2024 2022 2023 +2524 111 2027 2025 2026 +2525 111 2030 2028 2029 +2526 111 2033 2031 2032 +2527 111 2036 2034 2035 +2528 111 2039 2037 2038 +2529 111 2042 2040 2041 +2530 111 2045 2043 2044 +2531 111 2048 2046 2047 +2532 111 2051 2049 2050 +2533 111 2054 2052 2053 +2534 111 2057 2055 2056 +2535 111 2060 2058 2059 +2536 111 2063 2061 2062 +2537 111 2066 2064 2065 +2538 111 2069 2067 2068 +2539 111 2072 2070 2071 +2540 111 2075 2073 2074 +2541 111 2078 2076 2077 +2542 111 2081 2079 2080 +2543 111 2084 2082 2083 +2544 111 2087 2085 2086 +2545 111 2090 2088 2089 +2546 111 2093 2091 2092 +2547 111 2096 2094 2095 +2548 111 2099 2097 2098 +2549 111 2102 2100 2101 +2550 111 2105 2103 2104 +2551 111 2108 2106 2107 +2552 111 2111 2109 2110 +2553 111 2114 2112 2113 +2554 111 2117 2115 2116 +2555 111 2120 2118 2119 +2556 111 2123 2121 2122 +2557 111 2126 2124 2125 +2558 111 2129 2127 2128 +2559 111 2132 2130 2131 +2560 111 2135 2133 2134 +2561 111 2138 2136 2137 +2562 111 2141 2139 2140 +2563 111 2144 2142 2143 +2564 111 2147 2145 2146 +2565 111 2150 2148 2149 +2566 111 2153 2151 2152 +2567 111 2156 2154 2155 +2568 111 2159 2157 2158 +2569 111 2162 2160 2161 +2570 111 2165 2163 2164 +2571 111 2168 2166 2167 +2572 111 2171 2169 2170 +2573 111 2174 2172 2173 +2574 111 2177 2175 2176 +2575 111 2180 2178 2179 +2576 111 2183 2181 2182 +2577 111 2186 2184 2185 +2578 111 2189 2187 2188 +2579 111 2192 2190 2191 +2580 111 2195 2193 2194 +2581 111 2198 2196 2197 +2582 111 2201 2199 2200 +2583 111 2204 2202 2203 +2584 111 2207 2205 2206 +2585 111 2210 2208 2209 +2586 111 2213 2211 2212 +2587 111 2216 2214 2215 +2588 111 2219 2217 2218 +2589 111 2222 2220 2221 +2590 111 2225 2223 2224 +2591 111 2228 2226 2227 +2592 111 2231 2229 2230 +2593 111 2234 2232 2233 +2594 111 2237 2235 2236 +2595 111 2240 2238 2239 +2596 111 2243 2241 2242 +2597 111 2246 2244 2245 +2598 111 2249 2247 2248 +2599 111 2252 2250 2251 +2600 111 2255 2253 2254 +2601 111 2258 2256 2257 +2602 111 2261 2259 2260 +2603 111 2264 2262 2263 +2604 111 2267 2265 2266 +2605 111 2270 2268 2269 +2606 111 2273 2271 2272 +2607 111 2276 2274 2275 +2608 111 2279 2277 2278 +2609 111 2282 2280 2281 +2610 111 2285 2283 2284 +2611 111 2288 2286 2287 +2612 111 2291 2289 2290 +2613 111 2294 2292 2293 +2614 111 2297 2295 2296 +2615 111 2300 2298 2299 +2616 111 2303 2301 2302 +2617 111 2306 2304 2305 +2618 111 2309 2307 2308 +2619 111 2312 2310 2311 +2620 111 2315 2313 2314 +2621 111 2318 2316 2317 +2622 111 2321 2319 2320 +2623 111 2324 2322 2323 +2624 111 2327 2325 2326 +2625 111 2330 2328 2329 +2626 111 2333 2331 2332 +2627 111 2336 2334 2335 +2628 111 2339 2337 2338 +2629 111 2342 2340 2341 +2630 111 2345 2343 2344 +2631 111 2348 2346 2347 +2632 111 2351 2349 2350 +2633 111 2354 2352 2353 +2634 111 2357 2355 2356 +2635 111 2360 2358 2359 +2636 111 2363 2361 2362 +2637 111 2366 2364 2365 +2638 111 2369 2367 2368 +2639 111 2372 2370 2371 +2640 111 2375 2373 2374 +2641 111 2378 2376 2377 +2642 111 2381 2379 2380 +2643 111 2384 2382 2383 +2644 111 2387 2385 2386 +2645 111 2390 2388 2389 +2646 111 2393 2391 2392 +2647 111 2396 2394 2395 +2648 111 2399 2397 2398 +2649 111 2402 2400 2401 +2650 111 2405 2403 2404 +2651 111 2408 2406 2407 +2652 111 2411 2409 2410 +2653 111 2414 2412 2413 +2654 111 2417 2415 2416 +2655 111 2420 2418 2419 +2656 111 2423 2421 2422 +2657 111 2426 2424 2425 +2658 111 2429 2427 2428 +2659 111 2432 2430 2431 +2660 111 2435 2433 2434 +2661 111 2438 2436 2437 +2662 111 2441 2439 2440 +2663 111 2444 2442 2443 +2664 111 2447 2445 2446 +2665 111 2450 2448 2449 +2666 111 2453 2451 2452 +2667 111 2456 2454 2455 +2668 111 2459 2457 2458 +2669 111 2462 2460 2461 +2670 111 2465 2463 2464 +2671 111 2468 2466 2467 +2672 111 2471 2469 2470 +2673 111 2474 2472 2473 +2674 111 2477 2475 2476 +2675 111 2480 2478 2479 +2676 111 2483 2481 2482 +2677 111 2486 2484 2485 +2678 111 2489 2487 2488 +2679 111 2492 2490 2491 +2680 111 2495 2493 2494 +2681 111 2498 2496 2497 +2682 111 2501 2499 2500 +2683 111 2504 2502 2503 +2684 111 2507 2505 2506 +2685 111 2510 2508 2509 +2686 111 2513 2511 2512 +2687 111 2516 2514 2515 +2688 111 2519 2517 2518 +2689 111 2522 2520 2521 +2690 111 2525 2523 2524 +2691 111 2528 2526 2527 +2692 111 2531 2529 2530 +2693 111 2534 2532 2533 +2694 111 2537 2535 2536 +2695 111 2540 2538 2539 +2696 111 2543 2541 2542 +2697 111 2546 2544 2545 +2698 111 2549 2547 2548 +2699 111 2552 2550 2551 +2700 111 2555 2553 2554 +2701 111 2558 2556 2557 +2702 111 2561 2559 2560 +2703 111 2564 2562 2563 +2704 111 2567 2565 2566 +2705 111 2570 2568 2569 +2706 111 2573 2571 2572 +2707 111 2576 2574 2575 +2708 111 2579 2577 2578 +2709 111 2582 2580 2581 +2710 111 2585 2583 2584 +2711 111 2588 2586 2587 +2712 111 2591 2589 2590 +2713 111 2594 2592 2593 +2714 111 2597 2595 2596 +2715 111 2600 2598 2599 +2716 111 2603 2601 2602 +2717 111 2606 2604 2605 +2718 111 2609 2607 2608 +2719 111 2612 2610 2611 +2720 111 2615 2613 2614 +2721 111 2618 2616 2617 +2722 111 2621 2619 2620 +2723 111 2624 2622 2623 +2724 111 2627 2625 2626 +2725 111 2630 2628 2629 +2726 111 2633 2631 2632 +2727 111 2636 2634 2635 +2728 111 2639 2637 2638 +2729 111 2642 2640 2641 +2730 111 2645 2643 2644 +2731 111 2648 2646 2647 +2732 111 2651 2649 2650 +2733 111 2654 2652 2653 +2734 111 2657 2655 2656 +2735 111 2660 2658 2659 +2736 111 2663 2661 2662 +2737 111 2666 2664 2665 +2738 111 2669 2667 2668 +2739 111 2672 2670 2671 +2740 111 2675 2673 2674 +2741 111 2678 2676 2677 +2742 111 2681 2679 2680 +2743 111 2684 2682 2683 +2744 111 2687 2685 2686 +2745 111 2690 2688 2689 +2746 111 2693 2691 2692 +2747 111 2696 2694 2695 +2748 111 2699 2697 2698 +2749 111 2702 2700 2701 +2750 111 2705 2703 2704 +2751 111 2708 2706 2707 +2752 111 2711 2709 2710 +2753 111 2714 2712 2713 +2754 111 2717 2715 2716 +2755 111 2720 2718 2719 +2756 111 2723 2721 2722 +2757 111 2726 2724 2725 +2758 111 2729 2727 2728 +2759 111 2732 2730 2731 +2760 111 2735 2733 2734 +2761 111 2738 2736 2737 +2762 111 2741 2739 2740 +2763 111 2744 2742 2743 +2764 111 2747 2745 2746 +2765 111 2750 2748 2749 +2766 111 2753 2751 2752 +2767 111 2756 2754 2755 +2768 111 2759 2757 2758 +2769 111 2762 2760 2761 +2770 111 2765 2763 2764 +2771 111 2768 2766 2767 +2772 111 2771 2769 2770 +2773 111 2774 2772 2773 +2774 111 2777 2775 2776 +2775 111 2780 2778 2779 +2776 111 2783 2781 2782 +2777 111 2786 2784 2785 +2778 111 2789 2787 2788 +2779 111 2792 2790 2791 +2780 111 2795 2793 2794 +2781 111 2798 2796 2797 +2782 111 2801 2799 2800 +2783 111 2804 2802 2803 +2784 111 2807 2805 2806 +2785 111 2810 2808 2809 +2786 111 2813 2811 2812 +2787 111 2816 2814 2815 +2788 111 2819 2817 2818 +2789 111 2822 2820 2821 +2790 111 2825 2823 2824 +2791 111 2828 2826 2827 +2792 111 2831 2829 2830 +2793 111 2834 2832 2833 +2794 111 2837 2835 2836 +2795 111 2840 2838 2839 +2796 111 2843 2841 2842 +2797 111 2846 2844 2845 +2798 111 2849 2847 2848 +2799 111 2852 2850 2851 +2800 111 2855 2853 2854 +2801 111 2858 2856 2857 +2802 111 2861 2859 2860 +2803 111 2864 2862 2863 +2804 111 2867 2865 2866 +2805 111 2870 2868 2869 +2806 111 2873 2871 2872 +2807 111 2876 2874 2875 +2808 111 2879 2877 2878 +2809 111 2882 2880 2881 +2810 111 2885 2883 2884 +2811 111 2888 2886 2887 +2812 111 2891 2889 2890 +2813 111 2894 2892 2893 +2814 111 2897 2895 2896 +2815 111 2900 2898 2899 +2816 111 2903 2901 2902 +2817 111 2906 2904 2905 +2818 111 2909 2907 2908 +2819 111 2912 2910 2911 +2820 111 2915 2913 2914 +2821 111 2918 2916 2917 +2822 111 2921 2919 2920 +2823 111 2924 2922 2923 +2824 111 2927 2925 2926 +2825 111 2930 2928 2929 +2826 111 2933 2931 2932 +2827 111 2936 2934 2935 +2828 111 2939 2937 2938 +2829 111 2942 2940 2941 +2830 111 2945 2943 2944 +2831 111 2948 2946 2947 +2832 111 2951 2949 2950 +2833 111 2954 2952 2953 +2834 111 2957 2955 2956 +2835 111 2960 2958 2959 +2836 111 2963 2961 2962 +2837 111 2966 2964 2965 +2838 111 2969 2967 2968 +2839 111 2972 2970 2971 +2840 111 2975 2973 2974 +2841 111 2978 2976 2977 +2842 111 2981 2979 2980 +2843 111 2984 2982 2983 +2844 111 2987 2985 2986 +2845 111 2990 2988 2989 +2846 111 2993 2991 2992 +2847 111 2996 2994 2995 +2848 111 2999 2997 2998 +2849 111 3002 3000 3001 +2850 111 3005 3003 3004 +2851 111 3008 3006 3007 +2852 111 3011 3009 3010 +2853 111 3014 3012 3013 +2854 111 3017 3015 3016 +2855 111 3020 3018 3019 +2856 111 3023 3021 3022 +2857 111 3026 3024 3025 +2858 111 3029 3027 3028 +2859 111 3032 3030 3031 +2860 111 3035 3033 3034 +2861 111 3038 3036 3037 +2862 111 3041 3039 3040 +2863 111 3044 3042 3043 +2864 111 3047 3045 3046 +2865 111 3050 3048 3049 +2866 111 3053 3051 3052 +2867 111 3056 3054 3055 +2868 111 3059 3057 3058 +2869 111 3062 3060 3061 +2870 111 3065 3063 3064 +2871 111 3068 3066 3067 +2872 111 3071 3069 3070 +2873 111 3074 3072 3073 +2874 111 3077 3075 3076 +2875 111 3080 3078 3079 +2876 111 3083 3081 3082 +2877 111 3086 3084 3085 +2878 111 3089 3087 3088 +2879 111 3092 3090 3091 +2880 111 3095 3093 3094 +2881 111 3098 3096 3097 +2882 111 3101 3099 3100 +2883 111 3104 3102 3103 +2884 111 3107 3105 3106 +2885 111 3110 3108 3109 +2886 111 3113 3111 3112 +2887 111 3116 3114 3115 +2888 111 3119 3117 3118 +2889 111 3122 3120 3121 +2890 111 3125 3123 3124 +2891 111 3128 3126 3127 +2892 111 3131 3129 3130 +2893 111 3134 3132 3133 +2894 111 3137 3135 3136 +2895 111 3140 3138 3139 +2896 111 3143 3141 3142 +2897 111 3146 3144 3145 +2898 111 3149 3147 3148 +2899 111 3152 3150 3151 +2900 111 3155 3153 3154 +2901 111 3158 3156 3157 +2902 111 3161 3159 3160 +2903 111 3164 3162 3163 +2904 111 3167 3165 3166 +2905 111 3170 3168 3169 +2906 111 3173 3171 3172 +2907 111 3176 3174 3175 +2908 111 3179 3177 3178 +2909 111 3182 3180 3181 +2910 111 3185 3183 3184 +2911 111 3188 3186 3187 +2912 111 3191 3189 3190 +2913 111 3194 3192 3193 +2914 111 3197 3195 3196 +2915 111 3200 3198 3199 +2916 111 3203 3201 3202 +2917 111 3206 3204 3205 +2918 111 3209 3207 3208 +2919 111 3212 3210 3211 +2920 111 3215 3213 3214 +2921 111 3218 3216 3217 +2922 111 3221 3219 3220 +2923 111 3224 3222 3223 +2924 111 3227 3225 3226 +2925 111 3230 3228 3229 +2926 111 3233 3231 3232 +2927 111 3236 3234 3235 +2928 111 3239 3237 3238 +2929 111 3242 3240 3241 +2930 111 3245 3243 3244 +2931 111 3248 3246 3247 +2932 111 3251 3249 3250 +2933 111 3254 3252 3253 +2934 111 3257 3255 3256 +2935 111 3260 3258 3259 +2936 111 3263 3261 3262 +2937 111 3266 3264 3265 +2938 111 3269 3267 3268 +2939 111 3272 3270 3271 +2940 111 3275 3273 3274 +2941 111 3278 3276 3277 +2942 111 3281 3279 3280 +2943 111 3284 3282 3283 +2944 111 3287 3285 3286 +2945 111 3290 3288 3289 +2946 111 3293 3291 3292 +2947 111 3296 3294 3295 +2948 111 3299 3297 3298 +2949 111 3302 3300 3301 +2950 111 3305 3303 3304 +2951 111 3308 3306 3307 +2952 111 3311 3309 3310 +2953 111 3314 3312 3313 +2954 111 3317 3315 3316 +2955 111 3320 3318 3319 +2956 111 3323 3321 3322 +2957 111 3326 3324 3325 +2958 111 3329 3327 3328 +2959 111 3332 3330 3331 +2960 111 3335 3333 3334 +2961 111 3338 3336 3337 +2962 111 3341 3339 3340 +2963 111 3344 3342 3343 +2964 111 3347 3345 3346 +2965 111 3350 3348 3349 +2966 111 3353 3351 3352 +2967 111 3356 3354 3355 +2968 111 3359 3357 3358 +2969 111 3362 3360 3361 +2970 111 3365 3363 3364 +2971 111 3368 3366 3367 +2972 111 3371 3369 3370 +2973 111 3374 3372 3373 +2974 111 3377 3375 3376 +2975 111 3380 3378 3379 +2976 111 3383 3381 3382 +2977 111 3386 3384 3385 +2978 111 3389 3387 3388 +2979 111 3392 3390 3391 +2980 111 3395 3393 3394 +2981 111 3398 3396 3397 +2982 111 3401 3399 3400 +2983 111 3404 3402 3403 +2984 111 3407 3405 3406 +2985 111 3410 3408 3409 +2986 111 3413 3411 3412 +2987 111 3416 3414 3415 +2988 111 3419 3417 3418 +2989 111 3422 3420 3421 +2990 111 3425 3423 3424 +2991 111 3428 3426 3427 +2992 111 3431 3429 3430 +2993 111 3434 3432 3433 +2994 111 3437 3435 3436 +2995 111 3440 3438 3439 +2996 111 3443 3441 3442 +2997 111 3446 3444 3445 +2998 111 3449 3447 3448 +2999 111 3452 3450 3451 +3000 111 3455 3453 3454 +3001 111 3458 3456 3457 +3002 111 3461 3459 3460 +3003 111 3464 3462 3463 +3004 111 3467 3465 3466 +3005 111 3470 3468 3469 +3006 111 3473 3471 3472 +3007 111 3476 3474 3475 +3008 111 3479 3477 3478 +3009 111 3482 3480 3481 +3010 111 3485 3483 3484 +3011 111 3488 3486 3487 +3012 111 3491 3489 3490 +3013 111 3494 3492 3493 +3014 111 3497 3495 3496 +3015 111 3500 3498 3499 +3016 111 3503 3501 3502 +3017 111 3506 3504 3505 +3018 111 3509 3507 3508 +3019 111 3512 3510 3511 +3020 111 3515 3513 3514 +3021 111 3518 3516 3517 +3022 111 3521 3519 3520 +3023 111 3524 3522 3523 +3024 111 3527 3525 3526 +3025 111 3530 3528 3529 +3026 111 3533 3531 3532 +3027 111 3536 3534 3535 +3028 111 3539 3537 3538 +3029 111 3542 3540 3541 +3030 111 3545 3543 3544 +3031 111 3548 3546 3547 +3032 111 3551 3549 3550 +3033 111 3554 3552 3553 +3034 111 3557 3555 3556 +3035 111 3560 3558 3559 +3036 111 3563 3561 3562 +3037 111 3566 3564 3565 +3038 111 3569 3567 3568 +3039 111 3572 3570 3571 +3040 111 3575 3573 3574 +3041 111 3578 3576 3577 +3042 111 3581 3579 3580 +3043 111 3584 3582 3583 +3044 111 3587 3585 3586 +3045 111 3590 3588 3589 +3046 111 3593 3591 3592 +3047 111 3596 3594 3595 +3048 111 3599 3597 3598 +3049 111 3602 3600 3601 +3050 111 3605 3603 3604 +3051 111 3608 3606 3607 +3052 111 3611 3609 3610 +3053 111 3614 3612 3613 +3054 111 3617 3615 3616 +3055 111 3620 3618 3619 +3056 111 3623 3621 3622 +3057 111 3626 3624 3625 +3058 111 3629 3627 3628 +3059 111 3632 3630 3631 +3060 111 3635 3633 3634 +3061 111 3638 3636 3637 +3062 111 3641 3639 3640 +3063 111 3644 3642 3643 +3064 111 3647 3645 3646 +3065 111 3650 3648 3649 +3066 111 3653 3651 3652 +3067 111 3656 3654 3655 +3068 111 3659 3657 3658 +3069 111 3662 3660 3661 +3070 111 3665 3663 3664 +3071 111 3668 3666 3667 +3072 111 3671 3669 3670 +3073 111 3674 3672 3673 +3074 111 3677 3675 3676 +3075 111 3680 3678 3679 +3076 111 3683 3681 3682 +3077 111 3686 3684 3685 +3078 111 3689 3687 3688 +3079 111 3692 3690 3691 +3080 111 3695 3693 3694 +3081 111 3698 3696 3697 +3082 111 3701 3699 3700 +3083 111 3704 3702 3703 +3084 111 3707 3705 3706 +3085 111 3710 3708 3709 +3086 111 3713 3711 3712 +3087 111 3716 3714 3715 +3088 111 3719 3717 3718 +3089 111 3722 3720 3721 +3090 111 3725 3723 3724 +3091 111 3728 3726 3727 +3092 111 3731 3729 3730 +3093 111 3734 3732 3733 +3094 111 3737 3735 3736 +3095 111 3740 3738 3739 +3096 111 3743 3741 3742 +3097 111 3746 3744 3745 +3098 111 3749 3747 3748 +3099 111 3752 3750 3751 +3100 111 3755 3753 3754 +3101 111 3758 3756 3757 +3102 111 3761 3759 3760 +3103 111 3764 3762 3763 +3104 111 3767 3765 3766 +3105 111 3770 3768 3769 +3106 111 3773 3771 3772 +3107 111 3776 3774 3775 +3108 111 3779 3777 3778 +3109 111 3782 3780 3781 +3110 111 3785 3783 3784 +3111 111 3788 3786 3787 +3112 111 3791 3789 3790 +3113 111 3794 3792 3793 +3114 111 3797 3795 3796 +3115 111 3800 3798 3799 +3116 111 3803 3801 3802 +3117 111 3806 3804 3805 +3118 111 3809 3807 3808 +3119 111 3812 3810 3811 +3120 111 3815 3813 3814 +3121 111 3818 3816 3817 +3122 111 3821 3819 3820 +3123 111 3824 3822 3823 +3124 111 3827 3825 3826 +3125 111 3830 3828 3829 +3126 111 3833 3831 3832 +3127 111 3836 3834 3835 +3128 111 3839 3837 3838 +3129 111 3842 3840 3841 +3130 111 3845 3843 3844 +3131 111 3848 3846 3847 +3132 111 3851 3849 3850 +3133 111 3854 3852 3853 +3134 111 3857 3855 3856 +3135 111 3860 3858 3859 +3136 111 3863 3861 3862 +3137 111 3866 3864 3865 +3138 111 3869 3867 3868 +3139 111 3872 3870 3871 +3140 111 3875 3873 3874 +3141 111 3878 3876 3877 +3142 111 3881 3879 3880 +3143 111 3884 3882 3883 +3144 111 3887 3885 3886 +3145 111 3890 3888 3889 +3146 111 3893 3891 3892 +3147 111 3896 3894 3895 +3148 111 3899 3897 3898 +3149 111 3902 3900 3901 +3150 111 3905 3903 3904 +3151 111 3908 3906 3907 +3152 111 3911 3909 3910 +3153 111 3914 3912 3913 +3154 111 3917 3915 3916 +3155 111 3920 3918 3919 +3156 111 3923 3921 3922 +3157 111 3926 3924 3925 +3158 111 3929 3927 3928 +3159 111 3932 3930 3931 +3160 111 3935 3933 3934 +3161 111 3938 3936 3937 +3162 111 3941 3939 3940 +3163 111 3944 3942 3943 +3164 111 3947 3945 3946 +3165 111 3950 3948 3949 +3166 111 3953 3951 3952 +3167 111 3956 3954 3955 +3168 111 3959 3957 3958 +3169 111 3962 3960 3961 +3170 111 3965 3963 3964 +3171 111 3968 3966 3967 +3172 111 3971 3969 3970 +3173 111 3974 3972 3973 +3174 111 3977 3975 3976 +3175 111 3980 3978 3979 +3176 111 3983 3981 3982 +3177 111 3986 3984 3985 +3178 111 3989 3987 3988 +3179 111 3992 3990 3991 +3180 111 3995 3993 3994 +3181 111 3998 3996 3997 +3182 111 4001 3999 4000 +3183 111 4004 4002 4003 +3184 111 4007 4005 4006 +3185 111 4010 4008 4009 +3186 111 4013 4011 4012 +3187 111 4016 4014 4015 +3188 111 4019 4017 4018 +3189 111 4022 4020 4021 +3190 111 4025 4023 4024 +3191 111 4028 4026 4027 +3192 111 4031 4029 4030 +3193 111 4034 4032 4033 +3194 111 4037 4035 4036 +3195 111 4040 4038 4039 +3196 111 4043 4041 4042 +3197 111 4046 4044 4045 +3198 111 4049 4047 4048 +3199 111 4052 4050 4051 +3200 111 4055 4053 4054 +3201 111 4058 4056 4057 +3202 111 4061 4059 4060 +3203 111 4064 4062 4063 +3204 111 4067 4065 4066 +3205 111 4070 4068 4069 +3206 111 4073 4071 4072 +3207 111 4076 4074 4075 +3208 111 4079 4077 4078 +3209 111 4082 4080 4081 +3210 111 4085 4083 4084 +3211 111 4088 4086 4087 +3212 111 4091 4089 4090 +3213 111 4094 4092 4093 +3214 111 4097 4095 4096 +3215 111 4100 4098 4099 +3216 111 4103 4101 4102 +3217 111 4106 4104 4105 +3218 111 4109 4107 4108 +3219 111 4112 4110 4111 +3220 111 4115 4113 4114 +3221 111 4118 4116 4117 +3222 111 4121 4119 4120 +3223 111 4124 4122 4123 +3224 111 4127 4125 4126 +3225 111 4130 4128 4129 +3226 111 4133 4131 4132 +3227 111 4136 4134 4135 +3228 111 4139 4137 4138 +3229 111 4142 4140 4141 +3230 111 4145 4143 4144 +3231 111 4148 4146 4147 +3232 111 4151 4149 4150 +3233 111 4154 4152 4153 +3234 111 4157 4155 4156 +3235 111 4160 4158 4159 +3236 111 4163 4161 4162 +3237 111 4166 4164 4165 +3238 111 4169 4167 4168 +3239 111 4172 4170 4171 +3240 111 4175 4173 4174 +3241 111 4178 4176 4177 +3242 111 4181 4179 4180 +3243 111 4184 4182 4183 +3244 111 4187 4185 4186 +3245 111 4190 4188 4189 +3246 111 4193 4191 4192 +3247 111 4196 4194 4195 +3248 111 4199 4197 4198 +3249 111 4202 4200 4201 +3250 111 4205 4203 4204 +3251 111 4208 4206 4207 +3252 111 4211 4209 4210 +3253 111 4214 4212 4213 +3254 111 4217 4215 4216 +3255 111 4220 4218 4219 +3256 111 4223 4221 4222 +3257 111 4226 4224 4225 +3258 111 4229 4227 4228 +3259 111 4232 4230 4231 +3260 111 4235 4233 4234 +3261 111 4238 4236 4237 +3262 111 4241 4239 4240 +3263 111 4244 4242 4243 +3264 111 4247 4245 4246 +3265 111 4250 4248 4249 +3266 111 4253 4251 4252 +3267 111 4256 4254 4255 +3268 111 4259 4257 4258 +3269 111 4262 4260 4261 +3270 111 4265 4263 4264 +3271 111 4268 4266 4267 +3272 111 4271 4269 4270 +3273 111 4274 4272 4273 +3274 111 4277 4275 4276 +3275 111 4280 4278 4279 +3276 111 4283 4281 4282 +3277 111 4286 4284 4285 +3278 111 4289 4287 4288 +3279 111 4292 4290 4291 +3280 111 4295 4293 4294 +3281 111 4298 4296 4297 +3282 111 4301 4299 4300 +3283 111 4304 4302 4303 +3284 111 4307 4305 4306 +3285 111 4310 4308 4309 +3286 111 4313 4311 4312 +3287 111 4316 4314 4315 +3288 111 4319 4317 4318 +3289 111 4322 4320 4321 +3290 111 4325 4323 4324 +3291 111 4328 4326 4327 +3292 111 4331 4329 4330 +3293 111 4334 4332 4333 +3294 111 4337 4335 4336 +3295 111 4340 4338 4339 +3296 111 4343 4341 4342 +3297 111 4346 4344 4345 +3298 111 4349 4347 4348 +3299 111 4352 4350 4351 +3300 111 4355 4353 4354 +3301 111 4358 4356 4357 +3302 111 4361 4359 4360 +3303 111 4364 4362 4363 +3304 111 4367 4365 4366 +3305 111 4370 4368 4369 +3306 111 4373 4371 4372 +3307 111 4376 4374 4375 +3308 111 4379 4377 4378 +3309 111 4382 4380 4381 +3310 111 4385 4383 4384 +3311 111 4388 4386 4387 +3312 111 4391 4389 4390 +3313 111 4394 4392 4393 +3314 111 4397 4395 4396 +3315 111 4400 4398 4399 +3316 111 4403 4401 4402 +3317 111 4406 4404 4405 +3318 111 4409 4407 4408 +3319 111 4412 4410 4411 +3320 111 4415 4413 4414 +3321 111 4418 4416 4417 +3322 111 4421 4419 4420 +3323 111 4424 4422 4423 +3324 111 4427 4425 4426 +3325 111 4430 4428 4429 +3326 111 4433 4431 4432 +3327 111 4436 4434 4435 +3328 111 4439 4437 4438 +3329 111 4442 4440 4441 +3330 111 4445 4443 4444 +3331 111 4448 4446 4447 +3332 111 4451 4449 4450 +3333 111 4454 4452 4453 +3334 111 4457 4455 4456 +3335 111 4460 4458 4459 +3336 111 4463 4461 4462 +3337 111 4466 4464 4465 +3338 111 4469 4467 4468 +3339 111 4472 4470 4471 +3340 111 4475 4473 4474 +3341 111 4478 4476 4477 +3342 111 4481 4479 4480 +3343 111 4484 4482 4483 +3344 111 4487 4485 4486 +3345 111 4490 4488 4489 +3346 111 4493 4491 4492 +3347 111 4496 4494 4495 +3348 111 4499 4497 4498 +3349 111 4502 4500 4501 +3350 111 4505 4503 4504 +3351 111 4508 4506 4507 +3352 111 4511 4509 4510 +3353 111 4514 4512 4513 +3354 111 4517 4515 4516 +3355 111 4520 4518 4519 +3356 111 4523 4521 4522 +3357 111 4526 4524 4525 +3358 111 4529 4527 4528 +3359 111 4532 4530 4531 +3360 111 4535 4533 4534 +3361 111 4538 4536 4537 +3362 111 4541 4539 4540 +3363 111 4544 4542 4543 +3364 111 4547 4545 4546 +3365 111 4550 4548 4549 +3366 111 4553 4551 4552 +3367 111 4556 4554 4555 +3368 111 4559 4557 4558 +3369 111 4562 4560 4561 +3370 111 4565 4563 4564 +3371 111 4568 4566 4567 +3372 111 4571 4569 4570 +3373 111 4574 4572 4573 +3374 111 4577 4575 4576 +3375 111 4580 4578 4579 +3376 111 4583 4581 4582 +3377 111 4586 4584 4585 +3378 111 4589 4587 4588 +3379 111 4592 4590 4591 +3380 111 4595 4593 4594 +3381 111 4598 4596 4597 +3382 111 4601 4599 4600 +3383 111 4604 4602 4603 +3384 111 4607 4605 4606 +3385 111 4610 4608 4609 +3386 111 4613 4611 4612 +3387 111 4616 4614 4615 +3388 111 4619 4617 4618 +3389 111 4622 4620 4621 +3390 111 4625 4623 4624 +3391 111 4628 4626 4627 +3392 111 4631 4629 4630 +3393 111 4634 4632 4633 +3394 111 4637 4635 4636 +3395 111 4640 4638 4639 +3396 111 4643 4641 4642 +3397 111 4646 4644 4645 +3398 111 4649 4647 4648 +3399 111 4652 4650 4651 +3400 111 4655 4653 4654 +3401 111 4658 4656 4657 +3402 111 4661 4659 4660 +3403 111 4664 4662 4663 +3404 111 4667 4665 4666 +3405 111 4670 4668 4669 +3406 111 4673 4671 4672 +3407 111 4676 4674 4675 +3408 111 4679 4677 4678 +3409 111 4682 4680 4681 +3410 111 4685 4683 4684 +3411 111 4688 4686 4687 +3412 111 4691 4689 4690 +3413 111 4694 4692 4693 +3414 111 4697 4695 4696 +3415 111 4700 4698 4699 +3416 111 4703 4701 4702 +3417 111 4706 4704 4705 +3418 111 4709 4707 4708 +3419 111 4712 4710 4711 +3420 111 4715 4713 4714 +3421 111 4718 4716 4717 +3422 111 4721 4719 4720 +3423 111 4724 4722 4723 +3424 111 4727 4725 4726 +3425 111 4730 4728 4729 +3426 111 4733 4731 4732 +3427 111 4736 4734 4735 +3428 111 4739 4737 4738 +3429 111 4742 4740 4741 +3430 111 4745 4743 4744 +3431 111 4748 4746 4747 +3432 111 4751 4749 4750 +3433 111 4754 4752 4753 +3434 111 4757 4755 4756 +3435 111 4760 4758 4759 +3436 111 4763 4761 4762 +3437 111 4766 4764 4765 +3438 111 4769 4767 4768 +3439 111 4772 4770 4771 +3440 111 4775 4773 4774 +3441 111 4778 4776 4777 +3442 111 4781 4779 4780 +3443 111 4784 4782 4783 +3444 111 4787 4785 4786 +3445 111 4790 4788 4789 +3446 111 4793 4791 4792 +3447 111 4796 4794 4795 +3448 111 4799 4797 4798 +3449 111 4802 4800 4801 +3450 111 4805 4803 4804 +3451 111 4808 4806 4807 +3452 111 4811 4809 4810 +3453 111 4814 4812 4813 +3454 111 4817 4815 4816 +3455 111 4820 4818 4819 +3456 111 4823 4821 4822 +3457 111 4826 4824 4825 +3458 111 4829 4827 4828 +3459 111 4832 4830 4831 +3460 111 4835 4833 4834 +3461 111 4838 4836 4837 +3462 111 4841 4839 4840 +3463 111 4844 4842 4843 +3464 111 4847 4845 4846 +3465 111 4850 4848 4849 +3466 111 4853 4851 4852 +3467 111 4856 4854 4855 +3468 111 4859 4857 4858 +3469 111 4862 4860 4861 +3470 111 4865 4863 4864 +3471 111 4868 4866 4867 +3472 111 4871 4869 4870 +3473 111 4874 4872 4873 +3474 111 4877 4875 4876 +3475 111 4880 4878 4879 +3476 111 4883 4881 4882 +3477 111 4886 4884 4885 +3478 111 4889 4887 4888 +3479 111 4892 4890 4891 +3480 111 4895 4893 4894 +3481 111 4898 4896 4897 +3482 111 4901 4899 4900 +3483 111 4904 4902 4903 +3484 111 4907 4905 4906 +3485 111 4910 4908 4909 +3486 111 4913 4911 4912 +3487 111 4916 4914 4915 +3488 111 4919 4917 4918 +3489 111 4922 4920 4921 +3490 111 4925 4923 4924 +3491 111 4928 4926 4927 +3492 111 4931 4929 4930 +3493 111 4934 4932 4933 +3494 111 4937 4935 4936 +3495 111 4940 4938 4939 +3496 111 4943 4941 4942 +3497 111 4946 4944 4945 +3498 111 4949 4947 4948 +3499 111 4952 4950 4951 +3500 111 4955 4953 4954 +3501 111 4958 4956 4957 +3502 111 4961 4959 4960 +3503 111 4964 4962 4963 +3504 111 4967 4965 4966 +3505 111 4970 4968 4969 +3506 111 4973 4971 4972 +3507 111 4976 4974 4975 +3508 111 4979 4977 4978 +3509 111 4982 4980 4981 +3510 111 4985 4983 4984 +3511 111 4988 4986 4987 +3512 111 4991 4989 4990 +3513 111 4994 4992 4993 +3514 111 4997 4995 4996 +3515 111 5000 4998 4999 +3516 111 5003 5001 5002 +3517 111 5006 5004 5005 +3518 111 5009 5007 5008 +3519 111 5012 5010 5011 +3520 111 5015 5013 5014 +3521 111 5018 5016 5017 +3522 111 5021 5019 5020 +3523 111 5024 5022 5023 +3524 111 5027 5025 5026 +3525 111 5030 5028 5029 +3526 111 5033 5031 5032 +3527 111 5036 5034 5035 +3528 111 5039 5037 5038 +3529 111 5042 5040 5041 +3530 111 5045 5043 5044 +3531 111 5048 5046 5047 +3532 111 5051 5049 5050 +3533 111 5054 5052 5053 +3534 111 5057 5055 5056 +3535 111 5060 5058 5059 +3536 111 5063 5061 5062 +3537 111 5066 5064 5065 +3538 111 5069 5067 5068 +3539 111 5072 5070 5071 +3540 111 5075 5073 5074 +3541 111 5078 5076 5077 +3542 111 5081 5079 5080 +3543 111 5084 5082 5083 +3544 111 5087 5085 5086 +3545 111 5090 5088 5089 +3546 111 5093 5091 5092 +3547 111 5096 5094 5095 +3548 111 5099 5097 5098 +3549 111 5102 5100 5101 +3550 111 5105 5103 5104 +3551 111 5108 5106 5107 +3552 111 5111 5109 5110 +3553 111 5114 5112 5113 +3554 111 5117 5115 5116 +3555 111 5120 5118 5119 +3556 111 5123 5121 5122 +3557 111 5126 5124 5125 +3558 111 5129 5127 5128 +3559 111 5132 5130 5131 +3560 111 5135 5133 5134 +3561 111 5138 5136 5137 +3562 111 5141 5139 5140 +3563 111 5144 5142 5143 +3564 111 5147 5145 5146 +3565 111 5150 5148 5149 +3566 111 5153 5151 5152 +3567 111 5156 5154 5155 +3568 111 5159 5157 5158 +3569 111 5162 5160 5161 +3570 111 5165 5163 5164 +3571 111 5168 5166 5167 +3572 111 5171 5169 5170 +3573 111 5174 5172 5173 +3574 111 5177 5175 5176 +3575 111 5180 5178 5179 +3576 111 5183 5181 5182 +3577 111 5186 5184 5185 +3578 111 5189 5187 5188 +3579 111 5192 5190 5191 +3580 111 5195 5193 5194 +3581 111 5198 5196 5197 +3582 111 5201 5199 5200 +3583 111 5204 5202 5203 +3584 111 5207 5205 5206 +3585 111 5210 5208 5209 +3586 111 5213 5211 5212 +3587 111 5216 5214 5215 +3588 111 5219 5217 5218 +3589 111 5222 5220 5221 +3590 111 5225 5223 5224 +3591 111 5228 5226 5227 +3592 111 5231 5229 5230 +3593 111 5234 5232 5233 +3594 111 5237 5235 5236 +3595 111 5240 5238 5239 +3596 111 5243 5241 5242 +3597 111 5246 5244 5245 +3598 111 5249 5247 5248 +3599 111 5252 5250 5251 +3600 111 5255 5253 5254 +3601 111 5258 5256 5257 +3602 111 5261 5259 5260 +3603 111 5264 5262 5263 +3604 111 5267 5265 5266 +3605 111 5270 5268 5269 +3606 111 5273 5271 5272 +3607 111 5276 5274 5275 +3608 111 5279 5277 5278 +3609 111 5282 5280 5281 +3610 111 5285 5283 5284 +3611 111 5288 5286 5287 +3612 111 5291 5289 5290 +3613 111 5294 5292 5293 +3614 111 5297 5295 5296 +3615 111 5300 5298 5299 +3616 111 5303 5301 5302 +3617 111 5306 5304 5305 +3618 111 5309 5307 5308 +3619 111 5312 5310 5311 +3620 111 5315 5313 5314 +3621 111 5318 5316 5317 +3622 111 5321 5319 5320 +3623 111 5324 5322 5323 +3624 111 5327 5325 5326 +3625 111 5330 5328 5329 +3626 111 5333 5331 5332 +3627 111 5336 5334 5335 +3628 111 5339 5337 5338 +3629 111 5342 5340 5341 +3630 111 5345 5343 5344 +3631 111 5348 5346 5347 +3632 111 5351 5349 5350 +3633 111 5354 5352 5353 +3634 111 5357 5355 5356 +3635 111 5360 5358 5359 +3636 111 5363 5361 5362 +3637 111 5366 5364 5365 +3638 111 5369 5367 5368 +3639 111 5372 5370 5371 +3640 111 5375 5373 5374 +3641 111 5378 5376 5377 +3642 111 5381 5379 5380 +3643 111 5384 5382 5383 +3644 111 5387 5385 5386 +3645 111 5390 5388 5389 +3646 111 5393 5391 5392 +3647 111 5396 5394 5395 +3648 111 5399 5397 5398 +3649 111 5402 5400 5401 +3650 111 5405 5403 5404 +3651 111 5408 5406 5407 +3652 111 5411 5409 5410 +3653 111 5414 5412 5413 +3654 111 5417 5415 5416 +3655 111 5420 5418 5419 +3656 111 5423 5421 5422 +3657 111 5426 5424 5425 +3658 111 5429 5427 5428 +3659 111 5432 5430 5431 +3660 111 5435 5433 5434 +3661 111 5438 5436 5437 +3662 111 5441 5439 5440 +3663 111 5444 5442 5443 +3664 111 5447 5445 5446 +3665 111 5450 5448 5449 +3666 111 5453 5451 5452 +3667 111 5456 5454 5455 +3668 111 5459 5457 5458 +3669 111 5462 5460 5461 +3670 111 5465 5463 5464 +3671 111 5468 5466 5467 +3672 111 5471 5469 5470 +3673 111 5474 5472 5473 +3674 111 5477 5475 5476 +3675 111 5480 5478 5479 +3676 111 5483 5481 5482 +3677 111 5486 5484 5485 +3678 111 5489 5487 5488 +3679 111 5492 5490 5491 +3680 111 5495 5493 5494 +3681 111 5498 5496 5497 +3682 111 5501 5499 5500 +3683 111 5504 5502 5503 +3684 111 5507 5505 5506 +3685 111 5510 5508 5509 +3686 111 5513 5511 5512 +3687 111 5516 5514 5515 +3688 111 5519 5517 5518 +3689 111 5522 5520 5521 +3690 111 5525 5523 5524 +3691 111 5528 5526 5527 +3692 111 5531 5529 5530 +3693 111 5534 5532 5533 +3694 111 5537 5535 5536 +3695 111 5540 5538 5539 +3696 111 5543 5541 5542 +3697 111 5546 5544 5545 +3698 111 5549 5547 5548 +3699 111 5552 5550 5551 +3700 111 5555 5553 5554 +3701 111 5558 5556 5557 +3702 111 5561 5559 5560 +3703 111 5564 5562 5563 +3704 111 5567 5565 5566 +3705 111 5570 5568 5569 +3706 111 5573 5571 5572 +3707 111 5576 5574 5575 +3708 111 5579 5577 5578 +3709 111 5582 5580 5581 +3710 111 5585 5583 5584 +3711 111 5588 5586 5587 +3712 111 5591 5589 5590 +3713 111 5594 5592 5593 +3714 111 5597 5595 5596 +3715 111 5600 5598 5599 +3716 111 5603 5601 5602 +3717 111 5606 5604 5605 +3718 111 5609 5607 5608 +3719 111 5612 5610 5611 +3720 111 5615 5613 5614 +3721 111 5618 5616 5617 +3722 111 5621 5619 5620 +3723 111 5624 5622 5623 +3724 111 5627 5625 5626 +3725 111 5630 5628 5629 +3726 111 5633 5631 5632 +3727 111 5636 5634 5635 +3728 111 5639 5637 5638 +3729 111 5642 5640 5641 +3730 111 5645 5643 5644 +3731 111 5648 5646 5647 +3732 111 5651 5649 5650 +3733 111 5654 5652 5653 +3734 111 5657 5655 5656 +3735 111 5660 5658 5659 +3736 111 5663 5661 5662 +3737 111 5666 5664 5665 +3738 111 5669 5667 5668 +3739 111 5672 5670 5671 +3740 111 5675 5673 5674 +3741 111 5678 5676 5677 +3742 111 5681 5679 5680 +3743 111 5684 5682 5683 +3744 111 5687 5685 5686 +3745 111 5690 5688 5689 +3746 111 5693 5691 5692 +3747 111 5696 5694 5695 +3748 111 5699 5697 5698 +3749 111 5702 5700 5701 +3750 111 5705 5703 5704 +3751 111 5708 5706 5707 +3752 111 5711 5709 5710 +3753 111 5714 5712 5713 +3754 111 5717 5715 5716 +3755 111 5720 5718 5719 +3756 111 5723 5721 5722 +3757 111 5726 5724 5725 +3758 111 5729 5727 5728 +3759 111 5732 5730 5731 +3760 111 5735 5733 5734 +3761 111 5738 5736 5737 +3762 111 5741 5739 5740 +3763 111 5744 5742 5743 +3764 111 5747 5745 5746 +3765 111 5750 5748 5749 +3766 111 5753 5751 5752 +3767 111 5756 5754 5755 +3768 111 5759 5757 5758 +3769 111 5762 5760 5761 +3770 111 5765 5763 5764 +3771 111 5768 5766 5767 +3772 111 5771 5769 5770 +3773 111 5774 5772 5773 +3774 111 5777 5775 5776 +3775 111 5780 5778 5779 +3776 111 5783 5781 5782 +3777 111 5786 5784 5785 +3778 111 5789 5787 5788 +3779 111 5792 5790 5791 +3780 111 5795 5793 5794 +3781 111 5798 5796 5797 +3782 111 5801 5799 5800 +3783 111 5804 5802 5803 +3784 111 5807 5805 5806 +3785 111 5810 5808 5809 +3786 111 5813 5811 5812 +3787 111 5816 5814 5815 +3788 111 5819 5817 5818 +3789 111 5822 5820 5821 +3790 111 5825 5823 5824 +3791 111 5828 5826 5827 +3792 111 5831 5829 5830 +3793 111 5834 5832 5833 +3794 111 5837 5835 5836 +3795 111 5840 5838 5839 +3796 111 5843 5841 5842 +3797 111 5846 5844 5845 +3798 111 5849 5847 5848 +3799 111 5852 5850 5851 +3800 111 5855 5853 5854 +3801 111 5858 5856 5857 +3802 111 5861 5859 5860 +3803 111 5864 5862 5863 +3804 111 5867 5865 5866 +3805 111 5870 5868 5869 +3806 111 5873 5871 5872 +3807 111 5876 5874 5875 +3808 111 5879 5877 5878 +3809 111 5882 5880 5881 +3810 111 5885 5883 5884 +3811 111 5888 5886 5887 +3812 111 5891 5889 5890 +3813 111 5894 5892 5893 +3814 111 5897 5895 5896 +3815 111 5900 5898 5899 +3816 111 5903 5901 5902 +3817 111 5906 5904 5905 +3818 111 5909 5907 5908 +3819 111 5912 5910 5911 +3820 111 5915 5913 5914 +3821 111 5918 5916 5917 +3822 111 5921 5919 5920 +3823 111 5924 5922 5923 +3824 111 5927 5925 5926 +3825 111 5930 5928 5929 +3826 111 5933 5931 5932 +3827 111 5936 5934 5935 +3828 111 5939 5937 5938 +3829 111 5942 5940 5941 +3830 111 5945 5943 5944 +3831 111 5948 5946 5947 +3832 111 5951 5949 5950 +3833 111 5954 5952 5953 +3834 111 5957 5955 5956 +3835 111 5960 5958 5959 +3836 111 5963 5961 5962 +3837 111 5966 5964 5965 +3838 111 5969 5967 5968 +3839 111 5972 5970 5971 +3840 111 5975 5973 5974 +3841 111 5978 5976 5977 +3842 111 5981 5979 5980 +3843 111 5984 5982 5983 +3844 111 5987 5985 5986 +3845 111 5990 5988 5989 +3846 111 5993 5991 5992 +3847 111 5996 5994 5995 +3848 111 5999 5997 5998 +3849 111 6002 6000 6001 +3850 111 6005 6003 6004 +3851 111 6008 6006 6007 +3852 111 6011 6009 6010 +3853 111 6014 6012 6013 +3854 111 6017 6015 6016 +3855 111 6020 6018 6019 +3856 111 6023 6021 6022 +3857 111 6026 6024 6025 +3858 111 6029 6027 6028 +3859 111 6032 6030 6031 +3860 111 6035 6033 6034 +3861 111 6038 6036 6037 +3862 111 6041 6039 6040 +3863 111 6044 6042 6043 +3864 111 6047 6045 6046 +3865 111 6050 6048 6049 +3866 111 6053 6051 6052 +3867 111 6056 6054 6055 +3868 111 6059 6057 6058 +3869 111 6062 6060 6061 +3870 111 6065 6063 6064 +3871 111 6068 6066 6067 +3872 111 6071 6069 6070 +3873 111 6074 6072 6073 +3874 111 6077 6075 6076 +3875 111 6080 6078 6079 +3876 111 6083 6081 6082 +3877 111 6086 6084 6085 +3878 111 6089 6087 6088 +3879 111 6092 6090 6091 +3880 111 6095 6093 6094 +3881 111 6098 6096 6097 +3882 111 6101 6099 6100 +3883 111 6104 6102 6103 +3884 111 6107 6105 6106 +3885 111 6110 6108 6109 +3886 111 6113 6111 6112 +3887 111 6116 6114 6115 +3888 111 6119 6117 6118 +3889 111 6122 6120 6121 +3890 111 6125 6123 6124 +3891 111 6128 6126 6127 +3892 111 6131 6129 6130 +3893 111 6134 6132 6133 +3894 111 6137 6135 6136 +3895 111 6140 6138 6139 +3896 111 6143 6141 6142 +3897 111 6146 6144 6145 +3898 111 6149 6147 6148 +3899 111 6152 6150 6151 +3900 111 6155 6153 6154 +3901 111 6158 6156 6157 +3902 111 6161 6159 6160 +3903 111 6164 6162 6163 +3904 111 6167 6165 6166 +3905 111 6170 6168 6169 +3906 111 6173 6171 6172 +3907 111 6176 6174 6175 +3908 111 6179 6177 6178 +3909 111 6182 6180 6181 +3910 111 6185 6183 6184 +3911 111 6188 6186 6187 +3912 111 6191 6189 6190 +3913 111 6194 6192 6193 +3914 111 6197 6195 6196 +3915 111 6200 6198 6199 +3916 111 6203 6201 6202 +3917 111 6206 6204 6205 +3918 111 6209 6207 6208 +3919 111 6212 6210 6211 +3920 111 6215 6213 6214 +3921 111 6218 6216 6217 +3922 111 6221 6219 6220 +3923 111 6224 6222 6223 +3924 111 6227 6225 6226 +3925 111 6230 6228 6229 +3926 111 6233 6231 6232 +3927 111 6236 6234 6235 +3928 111 6239 6237 6238 +3929 111 6242 6240 6241 +3930 111 6245 6243 6244 +3931 111 6248 6246 6247 +3932 111 6251 6249 6250 +3933 111 6254 6252 6253 +3934 111 6257 6255 6256 +3935 111 6260 6258 6259 +3936 111 6263 6261 6262 +3937 111 6266 6264 6265 +3938 111 6269 6267 6268 +3939 111 6272 6270 6271 +3940 111 6275 6273 6274 +3941 111 6278 6276 6277 +3942 111 6281 6279 6280 +3943 111 6284 6282 6283 +3944 111 6287 6285 6286 +3945 111 6290 6288 6289 +3946 111 6293 6291 6292 +3947 111 6296 6294 6295 +3948 111 6299 6297 6298 +3949 111 6302 6300 6301 +3950 111 6305 6303 6304 +3951 111 6308 6306 6307 +3952 111 6311 6309 6310 +3953 111 6314 6312 6313 +3954 111 6317 6315 6316 +3955 111 6320 6318 6319 +3956 111 6323 6321 6322 +3957 111 6326 6324 6325 +3958 111 6329 6327 6328 +3959 111 6332 6330 6331 +3960 111 6335 6333 6334 +3961 111 6338 6336 6337 +3962 111 6341 6339 6340 +3963 111 6344 6342 6343 +3964 111 6347 6345 6346 +3965 111 6350 6348 6349 +3966 111 6353 6351 6352 +3967 111 6356 6354 6355 +3968 111 6359 6357 6358 +3969 111 6362 6360 6361 +3970 111 6365 6363 6364 +3971 111 6368 6366 6367 +3972 111 6371 6369 6370 +3973 111 6374 6372 6373 +3974 111 6377 6375 6376 +3975 111 6380 6378 6379 +3976 111 6383 6381 6382 +3977 111 6386 6384 6385 +3978 111 6389 6387 6388 +3979 111 6392 6390 6391 +3980 111 6395 6393 6394 +3981 111 6398 6396 6397 +3982 111 6401 6399 6400 +3983 111 6404 6402 6403 +3984 111 6407 6405 6406 +3985 111 6410 6408 6409 +3986 111 6413 6411 6412 +3987 111 6416 6414 6415 +3988 111 6419 6417 6418 +3989 111 6422 6420 6421 +3990 111 6425 6423 6424 +3991 111 6428 6426 6427 +3992 111 6431 6429 6430 +3993 111 6434 6432 6433 +3994 111 6437 6435 6436 +3995 111 6440 6438 6439 +3996 111 6443 6441 6442 +3997 111 6446 6444 6445 +3998 111 6449 6447 6448 +3999 111 6452 6450 6451 +4000 111 6455 6453 6454 +4001 111 6458 6456 6457 +4002 111 6461 6459 6460 +4003 111 6464 6462 6463 +4004 111 6467 6465 6466 +4005 111 6470 6468 6469 +4006 111 6473 6471 6472 +4007 111 6476 6474 6475 +4008 111 6479 6477 6478 +4009 111 6482 6480 6481 +4010 111 6485 6483 6484 +4011 111 6488 6486 6487 +4012 111 6491 6489 6490 +4013 111 6494 6492 6493 +4014 111 6497 6495 6496 +4015 111 6500 6498 6499 +4016 111 6503 6501 6502 +4017 111 6506 6504 6505 +4018 111 6509 6507 6508 +4019 111 6512 6510 6511 +4020 111 6515 6513 6514 +4021 111 6518 6516 6517 +4022 111 6521 6519 6520 +4023 111 6524 6522 6523 +4024 111 6527 6525 6526 +4025 111 6530 6528 6529 +4026 111 6533 6531 6532 +4027 111 6536 6534 6535 +4028 111 6539 6537 6538 +4029 111 6542 6540 6541 +4030 111 6545 6543 6544 +4031 111 6548 6546 6547 +4032 111 6551 6549 6550 +4033 111 6554 6552 6553 +4034 111 6557 6555 6556 +4035 111 6560 6558 6559 +4036 111 6563 6561 6562 +4037 111 6566 6564 6565 +4038 111 6569 6567 6568 +4039 111 6572 6570 6571 +4040 111 6575 6573 6574 +4041 111 6578 6576 6577 +4042 111 6581 6579 6580 +4043 111 6584 6582 6583 +4044 111 6587 6585 6586 +4045 111 6590 6588 6589 +4046 111 6593 6591 6592 +4047 111 6596 6594 6595 +4048 111 6599 6597 6598 +4049 111 6602 6600 6601 +4050 111 6605 6603 6604 +4051 111 6608 6606 6607 +4052 111 6611 6609 6610 +4053 111 6614 6612 6613 +4054 111 6617 6615 6616 +4055 111 6620 6618 6619 +4056 111 6623 6621 6622 +4057 111 6626 6624 6625 +4058 111 6629 6627 6628 +4059 111 6632 6630 6631 +4060 111 6635 6633 6634 +4061 111 6638 6636 6637 +4062 111 6641 6639 6640 +4063 111 6644 6642 6643 +4064 111 6647 6645 6646 +4065 111 6650 6648 6649 +4066 111 6653 6651 6652 +4067 111 6656 6654 6655 +4068 111 6659 6657 6658 +4069 111 6662 6660 6661 +4070 111 6665 6663 6664 +4071 111 6668 6666 6667 +4072 111 6671 6669 6670 +4073 111 6674 6672 6673 +4074 111 6677 6675 6676 +4075 111 6680 6678 6679 +4076 111 6683 6681 6682 +4077 111 6686 6684 6685 +4078 111 6689 6687 6688 +4079 111 6692 6690 6691 +4080 111 6695 6693 6694 +4081 111 6698 6696 6697 +4082 111 6701 6699 6700 +4083 111 6704 6702 6703 +4084 111 6707 6705 6706 +4085 111 6710 6708 6709 +4086 111 6713 6711 6712 +4087 111 6716 6714 6715 +4088 111 6719 6717 6718 +4089 111 6722 6720 6721 +4090 111 6725 6723 6724 +4091 111 6728 6726 6727 +4092 111 6731 6729 6730 +4093 111 6734 6732 6733 +4094 111 6737 6735 6736 +4095 111 6740 6738 6739 +4096 111 6743 6741 6742 +4097 111 6746 6744 6745 +4098 111 6749 6747 6748 +4099 111 6752 6750 6751 +4100 111 6755 6753 6754 +4101 111 6758 6756 6757 +4102 111 6761 6759 6760 +4103 111 6764 6762 6763 +4104 111 6767 6765 6766 +4105 111 6770 6768 6769 +4106 111 6773 6771 6772 +4107 111 6776 6774 6775 +4108 111 6779 6777 6778 +4109 111 6782 6780 6781 +4110 111 6785 6783 6784 +4111 111 6788 6786 6787 +4112 111 6791 6789 6790 +4113 111 6794 6792 6793 +4114 111 6797 6795 6796 +4115 111 6800 6798 6799 +4116 111 6803 6801 6802 +4117 111 6806 6804 6805 +4118 111 6809 6807 6808 +4119 111 6812 6810 6811 +4120 111 6815 6813 6814 +4121 111 6818 6816 6817 +4122 111 6821 6819 6820 +4123 111 6824 6822 6823 +4124 111 6827 6825 6826 +4125 111 6830 6828 6829 +4126 111 6833 6831 6832 +4127 111 6836 6834 6835 +4128 111 6839 6837 6838 +4129 111 6842 6840 6841 +4130 111 6845 6843 6844 +4131 111 6848 6846 6847 +4132 111 6851 6849 6850 +4133 111 6854 6852 6853 +4134 111 6857 6855 6856 +4135 111 6860 6858 6859 +4136 111 6863 6861 6862 +4137 111 6866 6864 6865 +4138 111 6869 6867 6868 +4139 111 6872 6870 6871 +4140 111 6875 6873 6874 +4141 111 6878 6876 6877 +4142 111 6881 6879 6880 +4143 111 6884 6882 6883 +4144 111 6887 6885 6886 +4145 111 6890 6888 6889 +4146 111 6893 6891 6892 +4147 111 6896 6894 6895 +4148 111 6899 6897 6898 +4149 111 6902 6900 6901 +4150 111 6905 6903 6904 +4151 111 6908 6906 6907 +4152 111 6911 6909 6910 +4153 111 6914 6912 6913 +4154 111 6917 6915 6916 +4155 111 6920 6918 6919 +4156 111 6923 6921 6922 +4157 111 6926 6924 6925 +4158 111 6929 6927 6928 +4159 111 6932 6930 6931 +4160 111 6935 6933 6934 +4161 111 6938 6936 6937 +4162 111 6941 6939 6940 +4163 111 6944 6942 6943 +4164 111 6947 6945 6946 +4165 111 6950 6948 6949 +4166 111 6953 6951 6952 +4167 111 6956 6954 6955 +4168 111 6959 6957 6958 +4169 111 6962 6960 6961 +4170 111 6965 6963 6964 +4171 111 6968 6966 6967 +4172 111 6971 6969 6970 +4173 111 6974 6972 6973 +4174 111 6977 6975 6976 +4175 111 6980 6978 6979 +4176 111 6983 6981 6982 +4177 111 6986 6984 6985 +4178 111 6989 6987 6988 +4179 111 6992 6990 6991 +4180 111 6995 6993 6994 +4181 111 6998 6996 6997 +4182 111 7001 6999 7000 +4183 111 7004 7002 7003 +4184 111 7007 7005 7006 +4185 111 7010 7008 7009 +4186 111 7013 7011 7012 +4187 111 7016 7014 7015 +4188 111 7019 7017 7018 +4189 111 7022 7020 7021 +4190 111 7025 7023 7024 +4191 111 7028 7026 7027 +4192 111 7031 7029 7030 +4193 111 7034 7032 7033 +4194 111 7037 7035 7036 +4195 111 7040 7038 7039 +4196 111 7043 7041 7042 +4197 111 7046 7044 7045 +4198 111 7049 7047 7048 +4199 111 7052 7050 7051 +4200 111 7055 7053 7054 +4201 111 7058 7056 7057 +4202 111 7061 7059 7060 +4203 111 7064 7062 7063 +4204 111 7067 7065 7066 +4205 111 7070 7068 7069 +4206 111 7073 7071 7072 +4207 111 7076 7074 7075 +4208 111 7079 7077 7078 +4209 111 7082 7080 7081 +4210 111 7085 7083 7084 +4211 111 7088 7086 7087 +4212 111 7091 7089 7090 +4213 111 7094 7092 7093 +4214 111 7097 7095 7096 +4215 111 7100 7098 7099 +4216 111 7103 7101 7102 +4217 111 7106 7104 7105 +4218 111 7109 7107 7108 +4219 111 7112 7110 7111 +4220 111 7115 7113 7114 +4221 111 7118 7116 7117 +4222 111 7121 7119 7120 +4223 111 7124 7122 7123 +4224 111 7127 7125 7126 +4225 111 7130 7128 7129 +4226 111 7133 7131 7132 +4227 111 7136 7134 7135 +4228 111 7139 7137 7138 +4229 111 7142 7140 7141 +4230 111 7145 7143 7144 +4231 111 7148 7146 7147 +4232 111 7151 7149 7150 +4233 111 7154 7152 7153 +4234 111 7157 7155 7156 +4235 111 7160 7158 7159 +4236 111 7163 7161 7162 +4237 111 7166 7164 7165 +4238 111 7169 7167 7168 +4239 111 7172 7170 7171 +4240 111 7175 7173 7174 +4241 111 7178 7176 7177 +4242 111 7181 7179 7180 +4243 111 7184 7182 7183 +4244 111 7187 7185 7186 +4245 111 7190 7188 7189 +4246 111 7193 7191 7192 +4247 111 7196 7194 7195 +4248 111 7199 7197 7198 +4249 111 7202 7200 7201 +4250 111 7205 7203 7204 +4251 111 7208 7206 7207 +4252 111 7211 7209 7210 +4253 111 7214 7212 7213 +4254 111 7217 7215 7216 +4255 111 7220 7218 7219 +4256 111 7223 7221 7222 +4257 111 7226 7224 7225 +4258 111 7229 7227 7228 +4259 111 7232 7230 7231 +4260 111 7235 7233 7234 +4261 111 7238 7236 7237 +4262 111 7241 7239 7240 +4263 111 7244 7242 7243 +4264 111 7247 7245 7246 +4265 111 7250 7248 7249 +4266 111 7253 7251 7252 +4267 111 7256 7254 7255 +4268 111 7259 7257 7258 +4269 111 7262 7260 7261 +4270 111 7265 7263 7264 +4271 111 7268 7266 7267 +4272 111 7271 7269 7270 +4273 111 7274 7272 7273 +4274 111 7277 7275 7276 +4275 111 7280 7278 7279 +4276 111 7283 7281 7282 +4277 111 7286 7284 7285 +4278 111 7289 7287 7288 +4279 111 7292 7290 7291 +4280 111 7295 7293 7294 +4281 111 7298 7296 7297 +4282 111 7301 7299 7300 +4283 111 7304 7302 7303 +4284 111 7307 7305 7306 +4285 111 7310 7308 7309 +4286 111 7313 7311 7312 +4287 111 7316 7314 7315 +4288 111 7319 7317 7318 +4289 111 7322 7320 7321 +4290 111 7325 7323 7324 +4291 111 7328 7326 7327 +4292 111 7331 7329 7330 +4293 111 7334 7332 7333 +4294 111 7337 7335 7336 +4295 111 7340 7338 7339 +4296 111 7343 7341 7342 +4297 111 7346 7344 7345 +4298 111 7349 7347 7348 +4299 111 7352 7350 7351 +4300 111 7355 7353 7354 +4301 111 7358 7356 7357 +4302 111 7361 7359 7360 +4303 111 7364 7362 7363 +4304 111 7367 7365 7366 +4305 111 7370 7368 7369 +4306 111 7373 7371 7372 +4307 111 7376 7374 7375 +4308 111 7379 7377 7378 +4309 111 7382 7380 7381 +4310 111 7385 7383 7384 +4311 111 7388 7386 7387 +4312 111 7391 7389 7390 +4313 111 7394 7392 7393 +4314 111 7397 7395 7396 +4315 111 7400 7398 7399 +4316 111 7403 7401 7402 +4317 111 7406 7404 7405 +4318 111 7409 7407 7408 +4319 111 7412 7410 7411 +4320 111 7415 7413 7414 +4321 111 7418 7416 7417 +4322 111 7421 7419 7420 +4323 111 7424 7422 7423 +4324 111 7427 7425 7426 +4325 111 7430 7428 7429 +4326 111 7433 7431 7432 +4327 111 7436 7434 7435 +4328 111 7439 7437 7438 +4329 111 7442 7440 7441 +4330 111 7445 7443 7444 +4331 111 7448 7446 7447 +4332 111 7451 7449 7450 +4333 111 7454 7452 7453 +4334 111 7457 7455 7456 +4335 111 7460 7458 7459 +4336 111 7463 7461 7462 +4337 111 7466 7464 7465 +4338 111 7469 7467 7468 +4339 111 7472 7470 7471 +4340 111 7475 7473 7474 +4341 111 7478 7476 7477 +4342 111 7481 7479 7480 +4343 111 7484 7482 7483 +4344 111 7487 7485 7486 +4345 111 7490 7488 7489 +4346 111 7493 7491 7492 +4347 111 7496 7494 7495 +4348 111 7499 7497 7498 +4349 111 7502 7500 7501 +4350 111 7505 7503 7504 +4351 111 7508 7506 7507 +4352 111 7511 7509 7510 +4353 111 7514 7512 7513 +4354 111 7517 7515 7516 +4355 111 7520 7518 7519 +4356 111 7523 7521 7522 +4357 111 7526 7524 7525 +4358 111 7529 7527 7528 +4359 111 7532 7530 7531 +4360 111 7535 7533 7534 +4361 111 7538 7536 7537 +4362 111 7541 7539 7540 +4363 111 7544 7542 7543 +4364 111 7547 7545 7546 +4365 111 7550 7548 7549 +4366 111 7553 7551 7552 +4367 111 7556 7554 7555 +4368 111 7559 7557 7558 +4369 111 7562 7560 7561 +4370 111 7565 7563 7564 +4371 111 7568 7566 7567 +4372 111 7571 7569 7570 +4373 111 7574 7572 7573 +4374 111 7577 7575 7576 +4375 111 7580 7578 7579 +4376 111 7583 7581 7582 +4377 111 7586 7584 7585 +4378 111 7589 7587 7588 +4379 111 7592 7590 7591 +4380 111 7595 7593 7594 +4381 111 7598 7596 7597 +4382 111 7601 7599 7600 +4383 111 7604 7602 7603 +4384 111 7607 7605 7606 +4385 111 7610 7608 7609 +4386 111 7613 7611 7612 +4387 111 7616 7614 7615 +4388 111 7619 7617 7618 +4389 111 7622 7620 7621 +4390 111 7625 7623 7624 +4391 111 7628 7626 7627 +4392 111 7631 7629 7630 +4393 111 7634 7632 7633 +4394 111 7637 7635 7636 +4395 111 7640 7638 7639 +4396 111 7643 7641 7642 +4397 111 7646 7644 7645 +4398 111 7649 7647 7648 +4399 111 7652 7650 7651 +4400 111 7655 7653 7654 +4401 111 7658 7656 7657 +4402 111 7661 7659 7660 +4403 111 7664 7662 7663 +4404 111 7667 7665 7666 +4405 111 7670 7668 7669 +4406 111 7673 7671 7672 +4407 111 7676 7674 7675 +4408 111 7679 7677 7678 +4409 111 7682 7680 7681 +4410 111 7685 7683 7684 +4411 111 7688 7686 7687 +4412 111 7691 7689 7690 +4413 111 7694 7692 7693 +4414 111 7697 7695 7696 +4415 111 7700 7698 7699 +4416 111 7703 7701 7702 +4417 111 7706 7704 7705 +4418 111 7709 7707 7708 +4419 111 7712 7710 7711 +4420 111 7715 7713 7714 +4421 111 7718 7716 7717 +4422 111 7721 7719 7720 +4423 111 7724 7722 7723 +4424 111 7727 7725 7726 +4425 111 7730 7728 7729 +4426 111 7733 7731 7732 +4427 111 7736 7734 7735 +4428 111 7739 7737 7738 +4429 111 7742 7740 7741 +4430 111 7745 7743 7744 +4431 111 7748 7746 7747 +4432 111 7751 7749 7750 +4433 111 7754 7752 7753 +4434 111 7757 7755 7756 +4435 111 7760 7758 7759 +4436 111 7763 7761 7762 +4437 111 7766 7764 7765 +4438 111 7769 7767 7768 +4439 111 7772 7770 7771 +4440 111 7775 7773 7774 +4441 111 7778 7776 7777 +4442 111 7781 7779 7780 +4443 111 7784 7782 7783 +4444 111 7787 7785 7786 +4445 111 7790 7788 7789 +4446 111 7793 7791 7792 +4447 111 7796 7794 7795 +4448 111 7799 7797 7798 +4449 111 7802 7800 7801 +4450 111 7805 7803 7804 +4451 111 7808 7806 7807 +4452 111 7811 7809 7810 +4453 111 7814 7812 7813 +4454 111 7817 7815 7816 +4455 111 7820 7818 7819 +4456 111 7823 7821 7822 +4457 111 7826 7824 7825 +4458 111 7829 7827 7828 +4459 111 7832 7830 7831 +4460 111 7835 7833 7834 +4461 111 7838 7836 7837 +4462 111 7841 7839 7840 +4463 111 7844 7842 7843 +4464 111 7847 7845 7846 +4465 111 7850 7848 7849 +4466 111 7853 7851 7852 +4467 111 7856 7854 7855 +4468 111 7859 7857 7858 +4469 111 7862 7860 7861 +4470 111 7865 7863 7864 +4471 111 7868 7866 7867 +4472 111 7871 7869 7870 +4473 111 7874 7872 7873 +4474 111 7877 7875 7876 +4475 111 7880 7878 7879 +4476 111 7883 7881 7882 +4477 111 7886 7884 7885 +4478 111 7889 7887 7888 +4479 111 7892 7890 7891 +4480 111 7895 7893 7894 +4481 111 7898 7896 7897 +4482 111 7901 7899 7900 +4483 111 7904 7902 7903 +4484 111 7907 7905 7906 +4485 111 7910 7908 7909 +4486 111 7913 7911 7912 +4487 111 7916 7914 7915 +4488 111 7919 7917 7918 +4489 111 7922 7920 7921 +4490 111 7925 7923 7924 +4491 111 7928 7926 7927 +4492 111 7931 7929 7930 +4493 111 7934 7932 7933 +4494 111 7937 7935 7936 +4495 111 7940 7938 7939 +4496 111 7943 7941 7942 +4497 111 7946 7944 7945 +4498 111 7949 7947 7948 +4499 111 7952 7950 7951 +4500 111 7955 7953 7954 +4501 111 7958 7956 7957 +4502 111 7961 7959 7960 +4503 111 7964 7962 7963 +4504 111 7967 7965 7966 +4505 111 7970 7968 7969 +4506 111 7973 7971 7972 +4507 111 7976 7974 7975 +4508 111 7979 7977 7978 +4509 111 7982 7980 7981 +4510 111 7985 7983 7984 +4511 111 7988 7986 7987 +4512 111 7991 7989 7990 +4513 111 7994 7992 7993 +4514 111 7997 7995 7996 +4515 111 8000 7998 7999 +4516 111 8003 8001 8002 +4517 111 8006 8004 8005 +4518 111 8009 8007 8008 +4519 111 8012 8010 8011 +4520 111 8015 8013 8014 +4521 111 8018 8016 8017 +4522 111 8021 8019 8020 +4523 111 8024 8022 8023 +4524 111 8027 8025 8026 +4525 111 8030 8028 8029 +4526 111 8033 8031 8032 +4527 111 8036 8034 8035 +4528 111 8039 8037 8038 +4529 111 8042 8040 8041 +4530 111 8045 8043 8044 +4531 111 8048 8046 8047 +4532 111 8051 8049 8050 +4533 111 8054 8052 8053 +4534 111 8057 8055 8056 +4535 111 8060 8058 8059 +4536 111 8063 8061 8062 +4537 111 8066 8064 8065 +4538 111 8069 8067 8068 +4539 111 8072 8070 8071 +4540 111 8075 8073 8074 +4541 111 8078 8076 8077 +4542 111 8081 8079 8080 +4543 111 8084 8082 8083 +4544 111 8087 8085 8086 +4545 111 8090 8088 8089 +4546 111 8093 8091 8092 +4547 111 8096 8094 8095 +4548 111 8099 8097 8098 +4549 111 8102 8100 8101 +4550 111 8105 8103 8104 +4551 111 8108 8106 8107 +4552 111 8111 8109 8110 +4553 111 8114 8112 8113 +4554 111 8117 8115 8116 +4555 111 8120 8118 8119 +4556 111 8123 8121 8122 +4557 111 8126 8124 8125 +4558 111 8129 8127 8128 +4559 111 8132 8130 8131 +4560 111 8135 8133 8134 +4561 111 8138 8136 8137 +4562 111 8141 8139 8140 +4563 111 8144 8142 8143 +4564 111 8147 8145 8146 +4565 111 8150 8148 8149 +4566 111 8153 8151 8152 +4567 111 8156 8154 8155 +4568 111 8159 8157 8158 +4569 111 8162 8160 8161 +4570 111 8165 8163 8164 +4571 111 8168 8166 8167 +4572 111 8171 8169 8170 +4573 111 8174 8172 8173 +4574 111 8177 8175 8176 +4575 111 8180 8178 8179 +4576 111 8183 8181 8182 +4577 111 8186 8184 8185 +4578 111 8189 8187 8188 +4579 111 8192 8190 8191 +4580 111 8195 8193 8194 +4581 111 8198 8196 8197 +4582 111 8201 8199 8200 +4583 111 8204 8202 8203 +4584 111 8207 8205 8206 +4585 111 8210 8208 8209 +4586 111 8213 8211 8212 +4587 111 8216 8214 8215 +4588 111 8219 8217 8218 +4589 111 8222 8220 8221 +4590 111 8225 8223 8224 +4591 111 8228 8226 8227 +4592 111 8231 8229 8230 +4593 111 8234 8232 8233 +4594 111 8237 8235 8236 +4595 111 8240 8238 8239 +4596 111 8243 8241 8242 +4597 111 8246 8244 8245 +4598 111 8249 8247 8248 +4599 111 8252 8250 8251 +4600 111 8255 8253 8254 +4601 111 8258 8256 8257 +4602 111 8261 8259 8260 +4603 111 8264 8262 8263 +4604 111 8267 8265 8266 +4605 111 8270 8268 8269 +4606 111 8273 8271 8272 +4607 111 8276 8274 8275 +4608 111 8279 8277 8278 +4609 111 8282 8280 8281 +4610 111 8285 8283 8284 +4611 111 8288 8286 8287 +4612 111 8291 8289 8290 +4613 111 8294 8292 8293 +4614 111 8297 8295 8296 +4615 111 8300 8298 8299 +4616 111 8303 8301 8302 +4617 111 8306 8304 8305 +4618 111 8309 8307 8308 +4619 111 8312 8310 8311 +4620 111 8315 8313 8314 +4621 111 8318 8316 8317 +4622 111 8321 8319 8320 +4623 111 8324 8322 8323 +4624 111 8327 8325 8326 +4625 111 8330 8328 8329 +4626 111 8333 8331 8332 +4627 111 8336 8334 8335 +4628 111 8339 8337 8338 +4629 111 8342 8340 8341 +4630 111 8345 8343 8344 +4631 111 8348 8346 8347 +4632 111 8351 8349 8350 +4633 111 8354 8352 8353 +4634 111 8357 8355 8356 +4635 111 8360 8358 8359 +4636 111 8363 8361 8362 +4637 111 8366 8364 8365 +4638 111 8369 8367 8368 +4639 111 8372 8370 8371 +4640 111 8375 8373 8374 +4641 111 8378 8376 8377 +4642 111 8381 8379 8380 +4643 111 8384 8382 8383 +4644 111 8387 8385 8386 +4645 111 8390 8388 8389 +4646 111 8393 8391 8392 +4647 111 8396 8394 8395 +4648 111 8399 8397 8398 +4649 111 8402 8400 8401 +4650 111 8405 8403 8404 +4651 111 8408 8406 8407 +4652 111 8411 8409 8410 +4653 111 8414 8412 8413 +4654 111 8417 8415 8416 +4655 111 8420 8418 8419 +4656 111 8423 8421 8422 +4657 111 8426 8424 8425 +4658 111 8429 8427 8428 +4659 111 8432 8430 8431 +4660 111 8435 8433 8434 +4661 111 8438 8436 8437 +4662 111 8441 8439 8440 +4663 111 8444 8442 8443 +4664 111 8447 8445 8446 +4665 111 8450 8448 8449 +4666 111 8453 8451 8452 +4667 111 8456 8454 8455 +4668 111 8459 8457 8458 +4669 111 8462 8460 8461 +4670 111 8465 8463 8464 +4671 111 8468 8466 8467 +4672 111 8471 8469 8470 +4673 111 8474 8472 8473 +4674 111 8477 8475 8476 +4675 111 8480 8478 8479 +4676 111 8483 8481 8482 +4677 111 8486 8484 8485 +4678 111 8489 8487 8488 +4679 111 8492 8490 8491 +4680 111 8495 8493 8494 +4681 111 8498 8496 8497 +4682 111 8501 8499 8500 +4683 111 8504 8502 8503 +4684 111 8507 8505 8506 +4685 111 8510 8508 8509 +4686 111 8513 8511 8512 +4687 111 8516 8514 8515 +4688 111 8519 8517 8518 +4689 111 8522 8520 8521 +4690 111 8525 8523 8524 +4691 111 8528 8526 8527 +4692 111 8531 8529 8530 +4693 111 8534 8532 8533 +4694 111 8537 8535 8536 +4695 111 8540 8538 8539 +4696 111 8543 8541 8542 +4697 111 8546 8544 8545 +4698 111 8549 8547 8548 +4699 111 8552 8550 8551 +4700 111 8555 8553 8554 +4701 111 8558 8556 8557 +4702 111 8561 8559 8560 +4703 111 8564 8562 8563 +4704 111 8567 8565 8566 +4705 111 8570 8568 8569 +4706 111 8573 8571 8572 +4707 111 8576 8574 8575 +4708 111 8579 8577 8578 +4709 111 8582 8580 8581 +4710 111 8585 8583 8584 +4711 111 8588 8586 8587 +4712 111 8591 8589 8590 +4713 111 8594 8592 8593 +4714 111 8597 8595 8596 +4715 111 8600 8598 8599 +4716 111 8603 8601 8602 +4717 111 8606 8604 8605 +4718 111 8609 8607 8608 +4719 111 8612 8610 8611 +4720 111 8615 8613 8614 +4721 111 8618 8616 8617 +4722 111 8621 8619 8620 +4723 111 8624 8622 8623 +4724 111 8627 8625 8626 +4725 111 8630 8628 8629 +4726 111 8633 8631 8632 +4727 111 8636 8634 8635 +4728 111 8639 8637 8638 +4729 111 8642 8640 8641 +4730 111 8645 8643 8644 +4731 111 8648 8646 8647 +4732 111 8651 8649 8650 +4733 111 8654 8652 8653 +4734 111 8657 8655 8656 +4735 111 8660 8658 8659 +4736 111 8663 8661 8662 +4737 111 8666 8664 8665 +4738 111 8669 8667 8668 +4739 111 8672 8670 8671 +4740 111 8675 8673 8674 +4741 111 8678 8676 8677 +4742 111 8681 8679 8680 +4743 111 8684 8682 8683 +4744 111 8687 8685 8686 +4745 111 8690 8688 8689 +4746 111 8693 8691 8692 +4747 111 8696 8694 8695 +4748 111 8699 8697 8698 +4749 111 8702 8700 8701 +4750 111 8705 8703 8704 +4751 111 8708 8706 8707 +4752 111 8711 8709 8710 +4753 111 8714 8712 8713 +4754 111 8717 8715 8716 +4755 111 8720 8718 8719 +4756 111 8723 8721 8722 +4757 111 8726 8724 8725 +4758 111 8729 8727 8728 +4759 111 8732 8730 8731 +4760 111 8735 8733 8734 +4761 111 8738 8736 8737 +4762 111 8741 8739 8740 +4763 111 8744 8742 8743 +4764 111 8747 8745 8746 +4765 111 8750 8748 8749 +4766 111 8753 8751 8752 +4767 111 8756 8754 8755 +4768 111 8759 8757 8758 +4769 111 8762 8760 8761 +4770 111 8765 8763 8764 +4771 111 8768 8766 8767 +4772 111 8771 8769 8770 +4773 111 8774 8772 8773 +4774 111 8777 8775 8776 +4775 111 8780 8778 8779 +4776 111 8783 8781 8782 +4777 111 8786 8784 8785 +4778 111 8789 8787 8788 +4779 111 8792 8790 8791 +4780 111 8795 8793 8794 +4781 111 8798 8796 8797 +4782 111 8801 8799 8800 +4783 111 8804 8802 8803 +4784 111 8807 8805 8806 +4785 111 8810 8808 8809 +4786 111 8813 8811 8812 +4787 111 8816 8814 8815 +4788 111 8819 8817 8818 +4789 111 8822 8820 8821 +4790 111 8825 8823 8824 +4791 111 8828 8826 8827 +4792 111 8831 8829 8830 +4793 111 8834 8832 8833 +4794 111 8837 8835 8836 +4795 111 8840 8838 8839 +4796 111 8843 8841 8842 +4797 111 8846 8844 8845 +4798 111 8849 8847 8848 +4799 111 8852 8850 8851 +4800 111 8855 8853 8854 +4801 111 8858 8856 8857 +4802 111 8861 8859 8860 +4803 111 8864 8862 8863 +4804 111 8867 8865 8866 +4805 111 8870 8868 8869 +4806 111 8873 8871 8872 +4807 111 8876 8874 8875 +4808 111 8879 8877 8878 +4809 111 8882 8880 8881 +4810 111 8885 8883 8884 +4811 111 8888 8886 8887 +4812 111 8891 8889 8890 +4813 111 8894 8892 8893 +4814 111 8897 8895 8896 +4815 111 8900 8898 8899 +4816 111 8903 8901 8902 +4817 111 8906 8904 8905 +4818 111 8909 8907 8908 +4819 111 8912 8910 8911 +4820 111 8915 8913 8914 +4821 111 8918 8916 8917 +4822 111 8921 8919 8920 +4823 111 8924 8922 8923 +4824 111 8927 8925 8926 +4825 111 8930 8928 8929 +4826 111 8933 8931 8932 +4827 111 8936 8934 8935 +4828 111 8939 8937 8938 +4829 111 8942 8940 8941 +4830 111 8945 8943 8944 +4831 111 8948 8946 8947 +4832 111 8951 8949 8950 +4833 111 8954 8952 8953 +4834 111 8957 8955 8956 +4835 111 8960 8958 8959 +4836 111 8963 8961 8962 +4837 111 8966 8964 8965 +4838 111 8969 8967 8968 +4839 111 8972 8970 8971 +4840 111 8975 8973 8974 +4841 111 8978 8976 8977 +4842 111 8981 8979 8980 +4843 111 8984 8982 8983 +4844 111 8987 8985 8986 +4845 111 8990 8988 8989 +4846 111 8993 8991 8992 +4847 111 8996 8994 8995 +4848 111 8999 8997 8998 +4849 111 9002 9000 9001 +4850 111 9005 9003 9004 +4851 111 9008 9006 9007 +4852 111 9011 9009 9010 +4853 111 9014 9012 9013 +4854 111 9017 9015 9016 +4855 111 9020 9018 9019 +4856 111 9023 9021 9022 +4857 111 9026 9024 9025 +4858 111 9029 9027 9028 +4859 111 9032 9030 9031 +4860 111 9035 9033 9034 +4861 111 9038 9036 9037 +4862 111 9041 9039 9040 +4863 111 9044 9042 9043 +4864 111 9047 9045 9046 +4865 111 9050 9048 9049 +4866 111 9053 9051 9052 +4867 111 9056 9054 9055 +4868 111 9059 9057 9058 +4869 111 9062 9060 9061 +4870 111 9065 9063 9064 +4871 111 9068 9066 9067 +4872 111 9071 9069 9070 +4873 111 9074 9072 9073 +4874 111 9077 9075 9076 +4875 111 9080 9078 9079 +4876 111 9083 9081 9082 +4877 111 9086 9084 9085 +4878 111 9089 9087 9088 +4879 111 9092 9090 9091 +4880 111 9095 9093 9094 +4881 111 9098 9096 9097 +4882 111 9101 9099 9100 +4883 111 9104 9102 9103 +4884 111 9107 9105 9106 +4885 111 9110 9108 9109 +4886 111 9113 9111 9112 +4887 111 9116 9114 9115 +4888 111 9119 9117 9118 +4889 111 9122 9120 9121 +4890 111 9125 9123 9124 +4891 111 9128 9126 9127 +4892 111 9131 9129 9130 +4893 111 9134 9132 9133 +4894 111 9137 9135 9136 +4895 111 9140 9138 9139 +4896 111 9143 9141 9142 +4897 111 9146 9144 9145 +4898 111 9149 9147 9148 +4899 111 9152 9150 9151 +4900 111 9155 9153 9154 +4901 111 9158 9156 9157 +4902 111 9161 9159 9160 +4903 111 9164 9162 9163 +4904 111 9167 9165 9166 +4905 111 9170 9168 9169 +4906 111 9173 9171 9172 +4907 111 9176 9174 9175 +4908 111 9179 9177 9178 +4909 111 9182 9180 9181 +4910 111 9185 9183 9184 +4911 111 9188 9186 9187 +4912 111 9191 9189 9190 +4913 111 9194 9192 9193 +4914 111 9197 9195 9196 +4915 111 9200 9198 9199 +4916 111 9203 9201 9202 +4917 111 9206 9204 9205 +4918 111 9209 9207 9208 +4919 111 9212 9210 9211 +4920 111 9215 9213 9214 +4921 111 9218 9216 9217 +4922 111 9221 9219 9220 +4923 111 9224 9222 9223 +4924 111 9227 9225 9226 +4925 111 9230 9228 9229 +4926 111 9233 9231 9232 +4927 111 9236 9234 9235 +4928 111 9239 9237 9238 +4929 111 9242 9240 9241 +4930 111 9245 9243 9244 +4931 111 9248 9246 9247 +4932 111 9251 9249 9250 +4933 111 9254 9252 9253 +4934 111 9257 9255 9256 +4935 111 9260 9258 9259 +4936 111 9263 9261 9262 +4937 111 9266 9264 9265 +4938 111 9269 9267 9268 +4939 111 9272 9270 9271 +4940 111 9275 9273 9274 +4941 111 9278 9276 9277 +4942 111 9281 9279 9280 +4943 111 9284 9282 9283 +4944 111 9287 9285 9286 +4945 111 9290 9288 9289 +4946 111 9293 9291 9292 +4947 111 9296 9294 9295 +4948 111 9299 9297 9298 +4949 111 9302 9300 9301 +4950 111 9305 9303 9304 +4951 111 9308 9306 9307 +4952 111 9311 9309 9310 +4953 111 9314 9312 9313 +4954 111 9317 9315 9316 +4955 111 9320 9318 9319 +4956 111 9323 9321 9322 +4957 111 9326 9324 9325 +4958 111 9329 9327 9328 +4959 111 9332 9330 9331 +4960 111 9335 9333 9334 +4961 111 9338 9336 9337 +4962 111 9341 9339 9340 +4963 111 9344 9342 9343 +4964 111 9347 9345 9346 +4965 111 9350 9348 9349 +4966 111 9353 9351 9352 +4967 111 9356 9354 9355 +4968 111 9359 9357 9358 +4969 111 9362 9360 9361 +4970 111 9365 9363 9364 +4971 111 9368 9366 9367 +4972 111 9371 9369 9370 +4973 111 9374 9372 9373 +4974 111 9377 9375 9376 +4975 111 9380 9378 9379 +4976 111 9383 9381 9382 +4977 111 9386 9384 9385 +4978 111 9389 9387 9388 +4979 111 9392 9390 9391 +4980 111 9395 9393 9394 +4981 111 9398 9396 9397 +4982 111 9401 9399 9400 +4983 111 9404 9402 9403 +4984 111 9407 9405 9406 +4985 111 9410 9408 9409 +4986 111 9413 9411 9412 +4987 111 9416 9414 9415 +4988 111 9419 9417 9418 +4989 111 9422 9420 9421 +4990 111 9425 9423 9424 +4991 111 9428 9426 9427 +4992 111 9431 9429 9430 +4993 111 9434 9432 9433 +4994 111 9437 9435 9436 +4995 111 9440 9438 9439 +4996 111 9443 9441 9442 +4997 111 9446 9444 9445 +4998 111 9449 9447 9448 +4999 111 9452 9450 9451 +5000 111 9455 9453 9454 +5001 111 9458 9456 9457 +5002 111 9461 9459 9460 +5003 111 9464 9462 9463 +5004 111 9467 9465 9466 +5005 111 9470 9468 9469 +5006 111 9473 9471 9472 +5007 111 9476 9474 9475 +5008 111 9479 9477 9478 +5009 111 9482 9480 9481 +5010 111 9485 9483 9484 +5011 111 9488 9486 9487 +5012 111 9491 9489 9490 +5013 111 9494 9492 9493 +5014 111 9497 9495 9496 +5015 111 9500 9498 9499 +5016 111 9503 9501 9502 +5017 111 9506 9504 9505 +5018 111 9509 9507 9508 +5019 111 9512 9510 9511 +5020 111 9515 9513 9514 +5021 111 9518 9516 9517 +5022 111 9521 9519 9520 +5023 111 9524 9522 9523 +5024 111 9527 9525 9526 +5025 111 9530 9528 9529 +5026 111 9533 9531 9532 +5027 111 9536 9534 9535 +5028 111 9539 9537 9538 +5029 111 9542 9540 9541 +5030 111 9545 9543 9544 +5031 111 9548 9546 9547 +5032 111 9551 9549 9550 +5033 111 9554 9552 9553 +5034 111 9557 9555 9556 +5035 111 9560 9558 9559 +5036 111 9563 9561 9562 +5037 111 9566 9564 9565 +5038 111 9569 9567 9568 +5039 111 9572 9570 9571 +5040 111 9575 9573 9574 +5041 111 9578 9576 9577 +5042 111 9581 9579 9580 +5043 111 9584 9582 9583 +5044 111 9587 9585 9586 +5045 111 9590 9588 9589 +5046 111 9593 9591 9592 +5047 111 9596 9594 9595 +5048 111 9599 9597 9598 +5049 111 9602 9600 9601 +5050 111 9605 9603 9604 +5051 111 9608 9606 9607 +5052 111 9611 9609 9610 +5053 111 9614 9612 9613 +5054 111 9617 9615 9616 +5055 111 9620 9618 9619 +5056 111 9623 9621 9622 +5057 111 9626 9624 9625 +5058 111 9629 9627 9628 +5059 111 9632 9630 9631 +5060 111 9635 9633 9634 +5061 111 9638 9636 9637 +5062 111 9641 9639 9640 +5063 111 9644 9642 9643 +5064 111 9647 9645 9646 +5065 111 9650 9648 9649 +5066 111 9653 9651 9652 +5067 111 9656 9654 9655 +5068 111 9659 9657 9658 +5069 111 9662 9660 9661 +5070 111 9665 9663 9664 +5071 111 9668 9666 9667 +5072 111 9671 9669 9670 +5073 111 9674 9672 9673 +5074 111 9677 9675 9676 +5075 111 9680 9678 9679 +5076 111 9683 9681 9682 +5077 111 9686 9684 9685 +5078 111 9689 9687 9688 +5079 111 9692 9690 9691 +5080 111 9695 9693 9694 +5081 111 9698 9696 9697 +5082 111 9701 9699 9700 +5083 111 9704 9702 9703 +5084 111 9707 9705 9706 +5085 111 9710 9708 9709 +5086 111 9713 9711 9712 +5087 111 9716 9714 9715 +5088 111 9719 9717 9718 +5089 111 9722 9720 9721 +5090 111 9725 9723 9724 +5091 111 9728 9726 9727 +5092 111 9731 9729 9730 +5093 111 9734 9732 9733 +5094 111 9737 9735 9736 + +Dihedrals + +1 1 5 1 2 3 +2 2 5 1 2 8 +3 3 5 1 2 9 +4 1 6 1 2 3 +5 2 6 1 2 8 +6 3 6 1 2 9 +7 1 7 1 2 3 +8 2 7 1 2 8 +9 3 7 1 2 9 +10 4 1 2 3 4 +11 5 1 2 3 20 +12 6 1 2 9 10 +13 7 1 2 9 13 +14 7 1 2 9 14 +15 8 3 2 9 10 +16 9 3 2 9 13 +17 9 3 2 9 14 +18 10 8 2 3 4 +19 11 8 2 3 20 +20 12 8 2 9 10 +21 13 8 2 9 13 +22 13 8 2 9 14 +23 14 9 2 3 4 +24 15 9 2 3 20 +25 16 2 3 20 21 +26 17 2 3 20 24 +27 18 4 3 20 21 +28 19 4 3 20 24 +29 20 2 9 10 11 +30 21 2 9 10 15 +31 21 2 9 10 16 +32 22 13 9 10 11 +33 23 13 9 10 15 +34 23 13 9 10 16 +35 22 14 9 10 11 +36 23 14 9 10 15 +37 23 14 9 10 16 +38 24 9 10 11 12 +39 25 15 10 11 12 +40 25 16 10 11 12 +41 25 10 11 12 17 +42 25 10 11 12 18 +43 25 10 11 12 19 +44 26 3 20 21 22 +45 27 3 20 21 25 +46 28 3 20 21 26 +47 29 24 20 21 22 +48 30 24 20 21 25 +49 31 24 20 21 26 +50 32 20 21 22 23 +51 33 20 21 22 37 +52 34 20 21 26 27 +53 35 20 21 26 31 +54 35 20 21 26 32 +55 8 22 21 26 27 +56 9 22 21 26 31 +57 9 22 21 26 32 +58 10 25 21 22 23 +59 11 25 21 22 37 +60 12 25 21 26 27 +61 13 25 21 26 31 +62 13 25 21 26 32 +63 14 26 21 22 23 +64 15 26 21 22 37 +65 16 21 22 37 38 +66 17 21 22 37 41 +67 18 23 22 37 38 +68 19 23 22 37 41 +69 36 21 26 27 28 +70 21 21 26 27 33 +71 21 21 26 27 34 +72 37 31 26 27 28 +73 23 31 26 27 33 +74 23 31 26 27 34 +75 37 32 26 27 28 +76 23 32 26 27 33 +77 23 32 26 27 34 +78 38 26 27 28 29 +79 39 26 27 28 30 +80 40 33 27 28 29 +81 41 33 27 28 30 +82 40 34 27 28 29 +83 41 34 27 28 30 +84 42 27 28 30 35 +85 42 27 28 30 36 +86 19 29 28 30 35 +87 19 29 28 30 36 +88 26 22 37 38 39 +89 27 22 37 38 42 +90 43 22 37 38 43 +91 29 41 37 38 39 +92 30 41 37 38 42 +93 44 41 37 38 43 +94 32 37 38 39 40 +95 33 37 38 39 56 +96 45 37 38 43 44 +97 45 37 38 43 45 +98 46 37 38 43 47 +99 47 39 38 43 44 +100 47 39 38 43 45 +101 48 39 38 43 47 +102 10 42 38 39 40 +103 11 42 38 39 56 +104 49 42 38 43 44 +105 49 42 38 43 45 +106 50 42 38 43 47 +107 51 43 38 39 40 +108 52 43 38 39 56 +109 16 38 39 56 57 +110 17 38 39 56 60 +111 18 40 39 56 57 +112 19 40 39 56 60 +113 53 38 43 44 46 +114 54 38 43 44 48 +115 54 38 43 44 49 +116 54 38 43 45 50 +117 54 38 43 45 51 +118 54 38 43 45 52 +119 55 44 43 45 50 +120 55 44 43 45 51 +121 55 44 43 45 52 +122 56 45 43 44 46 +123 55 45 43 44 48 +124 55 45 43 44 49 +125 12 47 43 44 46 +126 13 47 43 44 48 +127 13 47 43 44 49 +128 13 47 43 45 50 +129 13 47 43 45 51 +130 13 47 43 45 52 +131 21 43 44 46 53 +132 21 43 44 46 54 +133 21 43 44 46 55 +134 23 48 44 46 53 +135 23 48 44 46 54 +136 23 48 44 46 55 +137 23 49 44 46 53 +138 23 49 44 46 54 +139 23 49 44 46 55 +140 26 39 56 57 58 +141 27 39 56 57 61 +142 28 39 56 57 62 +143 29 60 56 57 58 +144 30 60 56 57 61 +145 31 60 56 57 62 +146 32 56 57 58 59 +147 33 56 57 58 76 +148 57 56 57 62 63 +149 35 56 57 62 69 +150 35 56 57 62 70 +151 58 58 57 62 63 +152 9 58 57 62 69 +153 9 58 57 62 70 +154 10 61 57 58 59 +155 11 61 57 58 76 +156 59 61 57 62 63 +157 13 61 57 62 69 +158 13 61 57 62 70 +159 14 62 57 58 59 +160 15 62 57 58 76 +161 16 57 58 76 77 +162 17 57 58 76 80 +163 18 59 58 76 77 +164 19 59 58 76 80 +165 60 57 62 63 64 +166 60 57 62 63 65 +167 61 69 62 63 64 +168 61 69 62 63 65 +169 61 70 62 63 64 +170 61 70 62 63 65 +171 62 62 63 64 66 +172 63 62 63 64 71 +173 62 62 63 65 67 +174 63 62 63 65 72 +175 64 64 63 65 67 +176 65 64 63 65 72 +177 64 65 63 64 66 +178 65 65 63 64 71 +179 64 63 64 66 68 +180 65 63 64 66 73 +181 65 71 64 66 68 +182 66 71 64 66 73 +183 64 63 65 67 68 +184 65 63 65 67 74 +185 65 72 65 67 68 +186 66 72 65 67 74 +187 64 64 66 68 67 +188 65 64 66 68 75 +189 65 73 66 68 67 +190 66 73 66 68 75 +191 64 65 67 68 66 +192 65 65 67 68 75 +193 65 74 67 68 66 +194 66 74 67 68 75 +195 26 58 76 77 78 +196 27 58 76 77 81 +197 43 58 76 77 82 +198 29 80 76 77 78 +199 30 80 76 77 81 +200 44 80 76 77 82 +201 32 76 77 78 79 +202 33 76 77 78 92 +203 45 76 77 82 83 +204 45 76 77 82 84 +205 46 76 77 82 85 +206 47 78 77 82 83 +207 47 78 77 82 84 +208 48 78 77 82 85 +209 10 81 77 78 79 +210 11 81 77 78 92 +211 49 81 77 82 83 +212 49 81 77 82 84 +213 50 81 77 82 85 +214 51 82 77 78 79 +215 52 82 77 78 92 +216 16 77 78 92 93 +217 17 77 78 92 96 +218 18 79 78 92 93 +219 19 79 78 92 96 +220 54 77 82 83 86 +221 54 77 82 83 87 +222 54 77 82 83 88 +223 54 77 82 84 89 +224 54 77 82 84 90 +225 54 77 82 84 91 +226 55 83 82 84 89 +227 55 83 82 84 90 +228 55 83 82 84 91 +229 55 84 82 83 86 +230 55 84 82 83 87 +231 55 84 82 83 88 +232 13 85 82 83 86 +233 13 85 82 83 87 +234 13 85 82 83 88 +235 13 85 82 84 89 +236 13 85 82 84 90 +237 13 85 82 84 91 +238 26 78 92 93 94 +239 27 78 92 93 97 +240 28 78 92 93 98 +241 29 96 92 93 94 +242 30 96 92 93 97 +243 31 96 92 93 98 +244 32 92 93 94 95 +245 33 92 93 94 114 +246 34 92 93 98 99 +247 35 92 93 98 103 +248 35 92 93 98 104 +249 8 94 93 98 99 +250 9 94 93 98 103 +251 9 94 93 98 104 +252 10 97 93 94 95 +253 11 97 93 94 114 +254 12 97 93 98 99 +255 13 97 93 98 103 +256 13 97 93 98 104 +257 14 98 93 94 95 +258 15 98 93 94 114 +259 16 93 94 114 115 +260 17 93 94 114 118 +261 18 95 94 114 115 +262 19 95 94 114 118 +263 67 93 98 99 100 +264 21 93 98 99 105 +265 21 93 98 99 106 +266 68 103 98 99 100 +267 23 103 98 99 105 +268 23 103 98 99 106 +269 68 104 98 99 100 +270 23 104 98 99 105 +271 23 104 98 99 106 +272 69 98 99 100 101 +273 68 98 99 100 107 +274 68 98 99 100 108 +275 68 105 99 100 101 +276 23 105 99 100 107 +277 23 105 99 100 108 +278 68 106 99 100 101 +279 23 106 99 100 107 +280 23 106 99 100 108 +281 70 99 100 101 102 +282 68 99 100 101 109 +283 68 99 100 101 110 +284 71 107 100 101 102 +285 23 107 100 101 109 +286 23 107 100 101 110 +287 71 108 100 101 102 +288 23 108 100 101 109 +289 23 108 100 101 110 +290 72 100 101 102 111 +291 72 100 101 102 112 +292 72 100 101 102 113 +293 73 109 101 102 111 +294 73 109 101 102 112 +295 73 109 101 102 113 +296 73 110 101 102 111 +297 73 110 101 102 112 +298 73 110 101 102 113 +299 26 94 114 115 116 +300 27 94 114 115 119 +301 43 94 114 115 120 +302 29 118 114 115 116 +303 30 118 114 115 119 +304 44 118 114 115 120 +305 32 114 115 116 117 +306 33 114 115 116 128 +307 74 114 115 120 121 +308 45 114 115 120 122 +309 46 114 115 120 123 +310 75 116 115 120 121 +311 47 116 115 120 122 +312 48 116 115 120 123 +313 10 119 115 116 117 +314 11 119 115 116 128 +315 76 119 115 120 121 +316 49 119 115 120 122 +317 50 119 115 120 123 +318 51 120 115 116 117 +319 52 120 115 116 128 +320 16 115 116 128 129 +321 17 115 116 128 132 +322 18 117 116 128 129 +323 19 117 116 128 132 +324 77 115 120 121 124 +325 54 115 120 122 125 +326 54 115 120 122 126 +327 54 115 120 122 127 +328 78 121 120 122 125 +329 78 121 120 122 126 +330 78 121 120 122 127 +331 79 122 120 121 124 +332 80 123 120 121 124 +333 13 123 120 122 125 +334 13 123 120 122 126 +335 13 123 120 122 127 +336 26 116 128 129 130 +337 27 116 128 129 133 +338 28 116 128 129 134 +339 29 132 128 129 130 +340 30 132 128 129 133 +341 31 132 128 129 134 +342 32 128 129 130 131 +343 33 128 129 130 147 +344 81 128 129 134 135 +345 35 128 129 134 138 +346 35 128 129 134 139 +347 82 130 129 134 135 +348 9 130 129 134 138 +349 9 130 129 134 139 +350 10 133 129 130 131 +351 11 133 129 130 147 +352 83 133 129 134 135 +353 13 133 129 134 138 +354 13 133 129 134 139 +355 14 134 129 130 131 +356 15 134 129 130 147 +357 16 129 130 147 148 +358 17 129 130 147 151 +359 18 131 130 147 148 +360 19 131 130 147 151 +361 84 129 134 135 136 +362 84 129 134 135 137 +363 83 129 134 135 140 +364 55 138 134 135 136 +365 55 138 134 135 137 +366 13 138 134 135 140 +367 55 139 134 135 136 +368 55 139 134 135 137 +369 13 139 134 135 140 +370 55 134 135 136 141 +371 55 134 135 136 142 +372 55 134 135 136 143 +373 55 134 135 137 144 +374 55 134 135 137 145 +375 55 134 135 137 146 +376 55 136 135 137 144 +377 55 136 135 137 145 +378 55 136 135 137 146 +379 55 137 135 136 141 +380 55 137 135 136 142 +381 55 137 135 136 143 +382 13 140 135 136 141 +383 13 140 135 136 142 +384 13 140 135 136 143 +385 13 140 135 137 144 +386 13 140 135 137 145 +387 13 140 135 137 146 +388 26 130 147 148 149 +389 27 130 147 148 152 +390 43 130 147 148 153 +391 29 151 147 148 149 +392 30 151 147 148 152 +393 44 151 147 148 153 +394 32 147 148 149 150 +395 33 147 148 149 161 +396 74 147 148 153 154 +397 45 147 148 153 155 +398 46 147 148 153 156 +399 75 149 148 153 154 +400 47 149 148 153 155 +401 48 149 148 153 156 +402 10 152 148 149 150 +403 11 152 148 149 161 +404 76 152 148 153 154 +405 49 152 148 153 155 +406 50 152 148 153 156 +407 51 153 148 149 150 +408 52 153 148 149 161 +409 85 148 149 161 162 +410 17 148 149 161 165 +411 86 150 149 161 162 +412 19 150 149 161 165 +413 77 148 153 154 157 +414 54 148 153 155 158 +415 54 148 153 155 159 +416 54 148 153 155 160 +417 78 154 153 155 158 +418 78 154 153 155 159 +419 78 154 153 155 160 +420 79 155 153 154 157 +421 80 156 153 154 157 +422 13 156 153 155 158 +423 13 156 153 155 159 +424 13 156 153 155 160 +425 87 149 161 162 163 +426 88 149 161 162 166 +427 88 149 161 162 167 +428 89 165 161 162 163 +429 90 165 161 162 166 +430 90 165 161 162 167 +431 91 161 162 163 164 +432 92 161 162 163 168 +433 93 166 162 163 164 +434 94 166 162 163 168 +435 93 167 162 163 164 +436 94 167 162 163 168 +437 95 162 163 168 169 +438 96 162 163 168 172 +439 18 164 163 168 169 +440 19 164 163 168 172 +441 26 163 168 169 170 +442 27 163 168 169 173 +443 28 163 168 169 174 +444 29 172 168 169 170 +445 30 172 168 169 173 +446 31 172 168 169 174 +447 32 168 169 170 171 +448 33 168 169 170 190 +449 34 168 169 174 175 +450 35 168 169 174 179 +451 35 168 169 174 180 +452 8 170 169 174 175 +453 9 170 169 174 179 +454 9 170 169 174 180 +455 10 173 169 170 171 +456 11 173 169 170 190 +457 12 173 169 174 175 +458 13 173 169 174 179 +459 13 173 169 174 180 +460 14 174 169 170 171 +461 15 174 169 170 190 +462 16 169 170 190 191 +463 17 169 170 190 194 +464 18 171 170 190 191 +465 19 171 170 190 194 +466 67 169 174 175 176 +467 21 169 174 175 181 +468 21 169 174 175 182 +469 68 179 174 175 176 +470 23 179 174 175 181 +471 23 179 174 175 182 +472 68 180 174 175 176 +473 23 180 174 175 181 +474 23 180 174 175 182 +475 69 174 175 176 177 +476 68 174 175 176 183 +477 68 174 175 176 184 +478 68 181 175 176 177 +479 23 181 175 176 183 +480 23 181 175 176 184 +481 68 182 175 176 177 +482 23 182 175 176 183 +483 23 182 175 176 184 +484 70 175 176 177 178 +485 68 175 176 177 185 +486 68 175 176 177 186 +487 71 183 176 177 178 +488 23 183 176 177 185 +489 23 183 176 177 186 +490 71 184 176 177 178 +491 23 184 176 177 185 +492 23 184 176 177 186 +493 72 176 177 178 187 +494 72 176 177 178 188 +495 72 176 177 178 189 +496 73 185 177 178 187 +497 73 185 177 178 188 +498 73 185 177 178 189 +499 73 186 177 178 187 +500 73 186 177 178 188 +501 73 186 177 178 189 +502 26 170 190 191 192 +503 27 170 190 191 195 +504 43 170 190 191 196 +505 29 194 190 191 192 +506 30 194 190 191 195 +507 44 194 190 191 196 +508 32 190 191 192 193 +509 33 190 191 192 204 +510 74 190 191 196 197 +511 45 190 191 196 198 +512 46 190 191 196 199 +513 75 192 191 196 197 +514 47 192 191 196 198 +515 48 192 191 196 199 +516 10 195 191 192 193 +517 11 195 191 192 204 +518 76 195 191 196 197 +519 49 195 191 196 198 +520 50 195 191 196 199 +521 51 196 191 192 193 +522 52 196 191 192 204 +523 16 191 192 204 205 +524 17 191 192 204 208 +525 18 193 192 204 205 +526 19 193 192 204 208 +527 77 191 196 197 200 +528 54 191 196 198 201 +529 54 191 196 198 202 +530 54 191 196 198 203 +531 78 197 196 198 201 +532 78 197 196 198 202 +533 78 197 196 198 203 +534 79 198 196 197 200 +535 80 199 196 197 200 +536 13 199 196 198 201 +537 13 199 196 198 202 +538 13 199 196 198 203 +539 26 192 204 205 206 +540 27 192 204 205 209 +541 43 192 204 205 210 +542 29 208 204 205 206 +543 30 208 204 205 209 +544 44 208 204 205 210 +545 32 204 205 206 207 +546 33 204 205 206 223 +547 45 204 205 210 211 +548 45 204 205 210 212 +549 46 204 205 210 214 +550 47 206 205 210 211 +551 47 206 205 210 212 +552 48 206 205 210 214 +553 10 209 205 206 207 +554 11 209 205 206 223 +555 49 209 205 210 211 +556 49 209 205 210 212 +557 50 209 205 210 214 +558 51 210 205 206 207 +559 52 210 205 206 223 +560 16 205 206 223 224 +561 17 205 206 223 227 +562 18 207 206 223 224 +563 19 207 206 223 227 +564 53 205 210 211 213 +565 54 205 210 211 215 +566 54 205 210 211 216 +567 54 205 210 212 217 +568 54 205 210 212 218 +569 54 205 210 212 219 +570 55 211 210 212 217 +571 55 211 210 212 218 +572 55 211 210 212 219 +573 56 212 210 211 213 +574 55 212 210 211 215 +575 55 212 210 211 216 +576 12 214 210 211 213 +577 13 214 210 211 215 +578 13 214 210 211 216 +579 13 214 210 212 217 +580 13 214 210 212 218 +581 13 214 210 212 219 +582 21 210 211 213 220 +583 21 210 211 213 221 +584 21 210 211 213 222 +585 23 215 211 213 220 +586 23 215 211 213 221 +587 23 215 211 213 222 +588 23 216 211 213 220 +589 23 216 211 213 221 +590 23 216 211 213 222 +591 26 206 223 224 225 +592 27 206 223 224 228 +593 43 206 223 224 229 +594 29 227 223 224 225 +595 30 227 223 224 228 +596 44 227 223 224 229 +597 32 223 224 225 226 +598 33 223 224 225 237 +599 74 223 224 229 230 +600 45 223 224 229 231 +601 46 223 224 229 232 +602 75 225 224 229 230 +603 47 225 224 229 231 +604 48 225 224 229 232 +605 10 228 224 225 226 +606 11 228 224 225 237 +607 76 228 224 229 230 +608 49 228 224 229 231 +609 50 228 224 229 232 +610 51 229 224 225 226 +611 52 229 224 225 237 +612 16 224 225 237 238 +613 17 224 225 237 241 +614 18 226 225 237 238 +615 19 226 225 237 241 +616 77 224 229 230 233 +617 54 224 229 231 234 +618 54 224 229 231 235 +619 54 224 229 231 236 +620 78 230 229 231 234 +621 78 230 229 231 235 +622 78 230 229 231 236 +623 79 231 229 230 233 +624 80 232 229 230 233 +625 13 232 229 231 234 +626 13 232 229 231 235 +627 13 232 229 231 236 +628 26 225 237 238 239 +629 27 225 237 238 242 +630 28 225 237 238 243 +631 29 241 237 238 239 +632 30 241 237 238 242 +633 31 241 237 238 243 +634 32 237 238 239 240 +635 33 237 238 239 256 +636 81 237 238 243 244 +637 35 237 238 243 247 +638 35 237 238 243 248 +639 82 239 238 243 244 +640 9 239 238 243 247 +641 9 239 238 243 248 +642 10 242 238 239 240 +643 11 242 238 239 256 +644 83 242 238 243 244 +645 13 242 238 243 247 +646 13 242 238 243 248 +647 14 243 238 239 240 +648 15 243 238 239 256 +649 16 238 239 256 257 +650 17 238 239 256 260 +651 18 240 239 256 257 +652 19 240 239 256 260 +653 84 238 243 244 245 +654 84 238 243 244 246 +655 83 238 243 244 249 +656 55 247 243 244 245 +657 55 247 243 244 246 +658 13 247 243 244 249 +659 55 248 243 244 245 +660 55 248 243 244 246 +661 13 248 243 244 249 +662 55 243 244 245 250 +663 55 243 244 245 251 +664 55 243 244 245 252 +665 55 243 244 246 253 +666 55 243 244 246 254 +667 55 243 244 246 255 +668 55 245 244 246 253 +669 55 245 244 246 254 +670 55 245 244 246 255 +671 55 246 244 245 250 +672 55 246 244 245 251 +673 55 246 244 245 252 +674 13 249 244 245 250 +675 13 249 244 245 251 +676 13 249 244 245 252 +677 13 249 244 246 253 +678 13 249 244 246 254 +679 13 249 244 246 255 +680 26 239 256 257 258 +681 27 239 256 257 261 +682 28 239 256 257 262 +683 29 260 256 257 258 +684 30 260 256 257 261 +685 31 260 256 257 262 +686 32 256 257 258 259 +687 33 256 257 258 271 +688 34 256 257 262 263 +689 35 256 257 262 267 +690 35 256 257 262 268 +691 8 258 257 262 263 +692 9 258 257 262 267 +693 9 258 257 262 268 +694 10 261 257 258 259 +695 11 261 257 258 271 +696 12 261 257 262 263 +697 13 261 257 262 267 +698 13 261 257 262 268 +699 14 262 257 258 259 +700 15 262 257 258 271 +701 16 257 258 271 272 +702 17 257 258 271 275 +703 18 259 258 271 272 +704 19 259 258 271 275 +705 97 257 262 263 264 +706 21 257 262 263 269 +707 21 257 262 263 270 +708 98 267 262 263 264 +709 23 267 262 263 269 +710 23 267 262 263 270 +711 98 268 262 263 264 +712 23 268 262 263 269 +713 23 268 262 263 270 +714 99 262 263 264 265 +715 99 262 263 264 266 +716 100 269 263 264 265 +717 100 269 263 264 266 +718 100 270 263 264 265 +719 100 270 263 264 266 +720 26 258 271 272 273 +721 27 258 271 272 276 +722 43 258 271 272 277 +723 29 275 271 272 273 +724 30 275 271 272 276 +725 44 275 271 272 277 +726 32 271 272 273 274 +727 33 271 272 273 287 +728 45 271 272 277 278 +729 45 271 272 277 279 +730 46 271 272 277 280 +731 47 273 272 277 278 +732 47 273 272 277 279 +733 48 273 272 277 280 +734 10 276 272 273 274 +735 11 276 272 273 287 +736 49 276 272 277 278 +737 49 276 272 277 279 +738 50 276 272 277 280 +739 51 277 272 273 274 +740 52 277 272 273 287 +741 16 272 273 287 288 +742 17 272 273 287 291 +743 18 274 273 287 288 +744 19 274 273 287 291 +745 54 272 277 278 281 +746 54 272 277 278 282 +747 54 272 277 278 283 +748 54 272 277 279 284 +749 54 272 277 279 285 +750 54 272 277 279 286 +751 55 278 277 279 284 +752 55 278 277 279 285 +753 55 278 277 279 286 +754 55 279 277 278 281 +755 55 279 277 278 282 +756 55 279 277 278 283 +757 13 280 277 278 281 +758 13 280 277 278 282 +759 13 280 277 278 283 +760 13 280 277 279 284 +761 13 280 277 279 285 +762 13 280 277 279 286 +763 26 273 287 288 289 +764 27 273 287 288 292 +765 28 273 287 288 293 +766 29 291 287 288 289 +767 30 291 287 288 292 +768 31 291 287 288 293 +769 32 287 288 289 290 +770 101 287 288 289 302 +771 34 287 288 293 294 +772 35 287 288 293 298 +773 35 287 288 293 299 +774 8 289 288 293 294 +775 9 289 288 293 298 +776 9 289 288 293 299 +777 10 292 288 289 290 +778 102 292 288 289 302 +779 12 292 288 293 294 +780 13 292 288 293 298 +781 13 292 288 293 299 +782 14 293 288 289 290 +783 103 293 288 289 302 +784 104 288 289 302 303 +785 105 288 289 302 309 +786 106 290 289 302 303 +787 107 290 289 302 309 +788 97 288 293 294 295 +789 21 288 293 294 300 +790 21 288 293 294 301 +791 98 298 293 294 295 +792 23 298 293 294 300 +793 23 298 293 294 301 +794 98 299 293 294 295 +795 23 299 293 294 300 +796 23 299 293 294 301 +797 99 293 294 295 296 +798 99 293 294 295 297 +799 100 300 294 295 296 +800 100 300 294 295 297 +801 100 301 294 295 296 +802 100 301 294 295 297 +803 108 289 302 303 304 +804 109 289 302 303 306 +805 110 289 302 303 307 +806 111 289 302 309 308 +807 112 289 302 309 314 +808 112 289 302 309 315 +809 113 303 302 309 308 +810 114 303 302 309 314 +811 114 303 302 309 315 +812 115 309 302 303 304 +813 116 309 302 303 306 +814 117 309 302 303 307 +815 118 302 303 304 305 +816 119 302 303 304 316 +817 120 302 303 307 308 +818 121 302 303 307 310 +819 121 302 303 307 311 +820 122 304 303 307 308 +821 123 304 303 307 310 +822 123 304 303 307 311 +823 10 306 303 304 305 +824 11 306 303 304 316 +825 124 306 303 307 308 +826 125 306 303 307 310 +827 125 306 303 307 311 +828 126 307 303 304 305 +829 127 307 303 304 316 +830 16 303 304 316 317 +831 17 303 304 316 320 +832 18 305 304 316 317 +833 19 305 304 316 320 +834 128 303 307 308 309 +835 129 303 307 308 312 +836 129 303 307 308 313 +837 130 310 307 308 309 +838 131 310 307 308 312 +839 131 310 307 308 313 +840 130 311 307 308 309 +841 131 311 307 308 312 +842 131 311 307 308 313 +843 132 307 308 309 302 +844 133 307 308 309 314 +845 133 307 308 309 315 +846 134 312 308 309 302 +847 135 312 308 309 314 +848 135 312 308 309 315 +849 134 313 308 309 302 +850 135 313 308 309 314 +851 135 313 308 309 315 +852 26 304 316 317 318 +853 27 304 316 317 321 +854 28 304 316 317 322 +855 29 320 316 317 318 +856 30 320 316 317 321 +857 31 320 316 317 322 +858 32 316 317 318 319 +859 33 316 317 318 327 +860 136 316 317 322 323 +861 35 316 317 322 324 +862 35 316 317 322 325 +863 137 318 317 322 323 +864 9 318 317 322 324 +865 9 318 317 322 325 +866 10 321 317 318 319 +867 11 321 317 318 327 +868 138 321 317 322 323 +869 13 321 317 322 324 +870 13 321 317 322 325 +871 14 322 317 318 319 +872 15 322 317 318 327 +873 16 317 318 327 328 +874 17 317 318 327 331 +875 18 319 318 327 328 +876 19 319 318 327 331 +877 139 317 322 323 326 +878 140 324 322 323 326 +879 140 325 322 323 326 +880 26 318 327 328 329 +881 27 318 327 328 332 +882 28 318 327 328 333 +883 29 331 327 328 329 +884 30 331 327 328 332 +885 31 331 327 328 333 +886 32 327 328 329 330 +887 33 327 328 329 339 +888 141 327 328 333 334 +889 35 327 328 333 337 +890 35 327 328 333 338 +891 142 329 328 333 334 +892 9 329 328 333 337 +893 9 329 328 333 338 +894 10 332 328 329 330 +895 11 332 328 329 339 +896 143 332 328 333 334 +897 13 332 328 333 337 +898 13 332 328 333 338 +899 14 333 328 329 330 +900 15 333 328 329 339 +901 16 328 329 339 340 +902 17 328 329 339 343 +903 18 330 329 339 340 +904 19 330 329 339 343 +905 144 328 333 334 335 +906 144 328 333 334 336 +907 100 337 333 334 335 +908 100 337 333 334 336 +909 100 338 333 334 335 +910 100 338 333 334 336 +911 26 329 339 340 341 +912 27 329 339 340 344 +913 43 329 339 340 345 +914 29 343 339 340 341 +915 30 343 339 340 344 +916 44 343 339 340 345 +917 32 339 340 341 342 +918 33 339 340 341 353 +919 74 339 340 345 346 +920 45 339 340 345 347 +921 46 339 340 345 348 +922 75 341 340 345 346 +923 47 341 340 345 347 +924 48 341 340 345 348 +925 10 344 340 341 342 +926 11 344 340 341 353 +927 76 344 340 345 346 +928 49 344 340 345 347 +929 50 344 340 345 348 +930 51 345 340 341 342 +931 52 345 340 341 353 +932 16 340 341 353 354 +933 17 340 341 353 357 +934 18 342 341 353 354 +935 19 342 341 353 357 +936 77 340 345 346 349 +937 54 340 345 347 350 +938 54 340 345 347 351 +939 54 340 345 347 352 +940 78 346 345 347 350 +941 78 346 345 347 351 +942 78 346 345 347 352 +943 79 347 345 346 349 +944 80 348 345 346 349 +945 13 348 345 347 350 +946 13 348 345 347 351 +947 13 348 345 347 352 +948 26 341 353 354 355 +949 27 341 353 354 358 +950 43 341 353 354 359 +951 29 357 353 354 355 +952 30 357 353 354 358 +953 44 357 353 354 359 +954 32 353 354 355 356 +955 33 353 354 355 372 +956 45 353 354 359 360 +957 45 353 354 359 361 +958 46 353 354 359 363 +959 47 355 354 359 360 +960 47 355 354 359 361 +961 48 355 354 359 363 +962 10 358 354 355 356 +963 11 358 354 355 372 +964 49 358 354 359 360 +965 49 358 354 359 361 +966 50 358 354 359 363 +967 51 359 354 355 356 +968 52 359 354 355 372 +969 16 354 355 372 373 +970 17 354 355 372 376 +971 18 356 355 372 373 +972 19 356 355 372 376 +973 53 354 359 360 362 +974 54 354 359 360 364 +975 54 354 359 360 365 +976 54 354 359 361 366 +977 54 354 359 361 367 +978 54 354 359 361 368 +979 55 360 359 361 366 +980 55 360 359 361 367 +981 55 360 359 361 368 +982 56 361 359 360 362 +983 55 361 359 360 364 +984 55 361 359 360 365 +985 12 363 359 360 362 +986 13 363 359 360 364 +987 13 363 359 360 365 +988 13 363 359 361 366 +989 13 363 359 361 367 +990 13 363 359 361 368 +991 21 359 360 362 369 +992 21 359 360 362 370 +993 21 359 360 362 371 +994 23 364 360 362 369 +995 23 364 360 362 370 +996 23 364 360 362 371 +997 23 365 360 362 369 +998 23 365 360 362 370 +999 23 365 360 362 371 +1000 26 355 372 373 374 +1001 27 355 372 373 377 +1002 28 355 372 373 378 +1003 29 376 372 373 374 +1004 30 376 372 373 377 +1005 31 376 372 373 378 +1006 32 372 373 374 375 +1007 33 372 373 374 387 +1008 34 372 373 378 379 +1009 35 372 373 378 383 +1010 35 372 373 378 384 +1011 8 374 373 378 379 +1012 9 374 373 378 383 +1013 9 374 373 378 384 +1014 10 377 373 374 375 +1015 11 377 373 374 387 +1016 12 377 373 378 379 +1017 13 377 373 378 383 +1018 13 377 373 378 384 +1019 14 378 373 374 375 +1020 15 378 373 374 387 +1021 16 373 374 387 388 +1022 17 373 374 387 391 +1023 18 375 374 387 388 +1024 19 375 374 387 391 +1025 97 373 378 379 380 +1026 21 373 378 379 385 +1027 21 373 378 379 386 +1028 98 383 378 379 380 +1029 23 383 378 379 385 +1030 23 383 378 379 386 +1031 98 384 378 379 380 +1032 23 384 378 379 385 +1033 23 384 378 379 386 +1034 99 378 379 380 381 +1035 99 378 379 380 382 +1036 100 385 379 380 381 +1037 100 385 379 380 382 +1038 100 386 379 380 381 +1039 100 386 379 380 382 +1040 26 374 387 388 389 +1041 27 374 387 388 392 +1042 28 374 387 388 393 +1043 29 391 387 388 389 +1044 30 391 387 388 392 +1045 31 391 387 388 393 +1046 32 387 388 389 390 +1047 33 387 388 389 401 +1048 145 387 388 393 394 +1049 35 387 388 393 397 +1050 35 387 388 393 398 +1051 146 389 388 393 394 +1052 9 389 388 393 397 +1053 9 389 388 393 398 +1054 10 392 388 389 390 +1055 11 392 388 389 401 +1056 147 392 388 393 394 +1057 13 392 388 393 397 +1058 13 392 388 393 398 +1059 14 393 388 389 390 +1060 15 393 388 389 401 +1061 16 388 389 401 402 +1062 17 388 389 401 405 +1063 18 390 389 401 402 +1064 19 390 389 401 405 +1065 148 388 393 394 395 +1066 149 388 393 394 396 +1067 40 397 393 394 395 +1068 41 397 393 394 396 +1069 40 398 393 394 395 +1070 41 398 393 394 396 +1071 42 393 394 396 399 +1072 42 393 394 396 400 +1073 19 395 394 396 399 +1074 19 395 394 396 400 +1075 26 389 401 402 403 +1076 27 389 401 402 406 +1077 43 389 401 402 407 +1078 29 405 401 402 403 +1079 30 405 401 402 406 +1080 44 405 401 402 407 +1081 32 401 402 403 404 +1082 33 401 402 403 417 +1083 45 401 402 407 408 +1084 45 401 402 407 409 +1085 46 401 402 407 410 +1086 47 403 402 407 408 +1087 47 403 402 407 409 +1088 48 403 402 407 410 +1089 10 406 402 403 404 +1090 11 406 402 403 417 +1091 49 406 402 407 408 +1092 49 406 402 407 409 +1093 50 406 402 407 410 +1094 51 407 402 403 404 +1095 52 407 402 403 417 +1096 16 402 403 417 418 +1097 17 402 403 417 421 +1098 18 404 403 417 418 +1099 19 404 403 417 421 +1100 54 402 407 408 411 +1101 54 402 407 408 412 +1102 54 402 407 408 413 +1103 54 402 407 409 414 +1104 54 402 407 409 415 +1105 54 402 407 409 416 +1106 55 408 407 409 414 +1107 55 408 407 409 415 +1108 55 408 407 409 416 +1109 55 409 407 408 411 +1110 55 409 407 408 412 +1111 55 409 407 408 413 +1112 13 410 407 408 411 +1113 13 410 407 408 412 +1114 13 410 407 408 413 +1115 13 410 407 409 414 +1116 13 410 407 409 415 +1117 13 410 407 409 416 +1118 26 403 417 418 419 +1119 27 403 417 418 422 +1120 28 403 417 418 423 +1121 29 421 417 418 419 +1122 30 421 417 418 422 +1123 31 421 417 418 423 +1124 32 417 418 419 420 +1125 33 417 418 419 439 +1126 34 417 418 423 424 +1127 35 417 418 423 428 +1128 35 417 418 423 429 +1129 8 419 418 423 424 +1130 9 419 418 423 428 +1131 9 419 418 423 429 +1132 10 422 418 419 420 +1133 11 422 418 419 439 +1134 12 422 418 423 424 +1135 13 422 418 423 428 +1136 13 422 418 423 429 +1137 14 423 418 419 420 +1138 15 423 418 419 439 +1139 16 418 419 439 440 +1140 17 418 419 439 443 +1141 18 420 419 439 440 +1142 19 420 419 439 443 +1143 67 418 423 424 425 +1144 21 418 423 424 430 +1145 21 418 423 424 431 +1146 68 428 423 424 425 +1147 23 428 423 424 430 +1148 23 428 423 424 431 +1149 68 429 423 424 425 +1150 23 429 423 424 430 +1151 23 429 423 424 431 +1152 69 423 424 425 426 +1153 68 423 424 425 432 +1154 68 423 424 425 433 +1155 68 430 424 425 426 +1156 23 430 424 425 432 +1157 23 430 424 425 433 +1158 68 431 424 425 426 +1159 23 431 424 425 432 +1160 23 431 424 425 433 +1161 70 424 425 426 427 +1162 68 424 425 426 434 +1163 68 424 425 426 435 +1164 71 432 425 426 427 +1165 23 432 425 426 434 +1166 23 432 425 426 435 +1167 71 433 425 426 427 +1168 23 433 425 426 434 +1169 23 433 425 426 435 +1170 72 425 426 427 436 +1171 72 425 426 427 437 +1172 72 425 426 427 438 +1173 73 434 426 427 436 +1174 73 434 426 427 437 +1175 73 434 426 427 438 +1176 73 435 426 427 436 +1177 73 435 426 427 437 +1178 73 435 426 427 438 +1179 26 419 439 440 441 +1180 27 419 439 440 444 +1181 28 419 439 440 445 +1182 29 443 439 440 441 +1183 30 443 439 440 444 +1184 31 443 439 440 445 +1185 32 439 440 441 442 +1186 33 439 440 441 449 +1187 35 439 440 445 446 +1188 35 439 440 445 447 +1189 35 439 440 445 448 +1190 9 441 440 445 446 +1191 9 441 440 445 447 +1192 9 441 440 445 448 +1193 10 444 440 441 442 +1194 11 444 440 441 449 +1195 13 444 440 445 446 +1196 13 444 440 445 447 +1197 13 444 440 445 448 +1198 14 445 440 441 442 +1199 15 445 440 441 449 +1200 16 440 441 449 450 +1201 17 440 441 449 453 +1202 18 442 441 449 450 +1203 19 442 441 449 453 +1204 26 441 449 450 451 +1205 27 441 449 450 454 +1206 28 441 449 450 455 +1207 29 453 449 450 451 +1208 30 453 449 450 454 +1209 31 453 449 450 455 +1210 32 449 450 451 452 +1211 33 449 450 451 471 +1212 34 449 450 455 456 +1213 35 449 450 455 460 +1214 35 449 450 455 461 +1215 8 451 450 455 456 +1216 9 451 450 455 460 +1217 9 451 450 455 461 +1218 10 454 450 451 452 +1219 11 454 450 451 471 +1220 12 454 450 455 456 +1221 13 454 450 455 460 +1222 13 454 450 455 461 +1223 14 455 450 451 452 +1224 15 455 450 451 471 +1225 16 450 451 471 472 +1226 17 450 451 471 475 +1227 18 452 451 471 472 +1228 19 452 451 471 475 +1229 67 450 455 456 457 +1230 21 450 455 456 462 +1231 21 450 455 456 463 +1232 68 460 455 456 457 +1233 23 460 455 456 462 +1234 23 460 455 456 463 +1235 68 461 455 456 457 +1236 23 461 455 456 462 +1237 23 461 455 456 463 +1238 69 455 456 457 458 +1239 68 455 456 457 464 +1240 68 455 456 457 465 +1241 68 462 456 457 458 +1242 23 462 456 457 464 +1243 23 462 456 457 465 +1244 68 463 456 457 458 +1245 23 463 456 457 464 +1246 23 463 456 457 465 +1247 70 456 457 458 459 +1248 68 456 457 458 466 +1249 68 456 457 458 467 +1250 71 464 457 458 459 +1251 23 464 457 458 466 +1252 23 464 457 458 467 +1253 71 465 457 458 459 +1254 23 465 457 458 466 +1255 23 465 457 458 467 +1256 72 457 458 459 468 +1257 72 457 458 459 469 +1258 72 457 458 459 470 +1259 73 466 458 459 468 +1260 73 466 458 459 469 +1261 73 466 458 459 470 +1262 73 467 458 459 468 +1263 73 467 458 459 469 +1264 73 467 458 459 470 +1265 26 451 471 472 473 +1266 27 451 471 472 476 +1267 43 451 471 472 477 +1268 29 475 471 472 473 +1269 30 475 471 472 476 +1270 44 475 471 472 477 +1271 32 471 472 473 474 +1272 33 471 472 473 490 +1273 45 471 472 477 478 +1274 45 471 472 477 479 +1275 46 471 472 477 481 +1276 47 473 472 477 478 +1277 47 473 472 477 479 +1278 48 473 472 477 481 +1279 10 476 472 473 474 +1280 11 476 472 473 490 +1281 49 476 472 477 478 +1282 49 476 472 477 479 +1283 50 476 472 477 481 +1284 51 477 472 473 474 +1285 52 477 472 473 490 +1286 16 472 473 490 491 +1287 17 472 473 490 494 +1288 18 474 473 490 491 +1289 19 474 473 490 494 +1290 53 472 477 478 480 +1291 54 472 477 478 482 +1292 54 472 477 478 483 +1293 54 472 477 479 484 +1294 54 472 477 479 485 +1295 54 472 477 479 486 +1296 55 478 477 479 484 +1297 55 478 477 479 485 +1298 55 478 477 479 486 +1299 56 479 477 478 480 +1300 55 479 477 478 482 +1301 55 479 477 478 483 +1302 12 481 477 478 480 +1303 13 481 477 478 482 +1304 13 481 477 478 483 +1305 13 481 477 479 484 +1306 13 481 477 479 485 +1307 13 481 477 479 486 +1308 21 477 478 480 487 +1309 21 477 478 480 488 +1310 21 477 478 480 489 +1311 23 482 478 480 487 +1312 23 482 478 480 488 +1313 23 482 478 480 489 +1314 23 483 478 480 487 +1315 23 483 478 480 488 +1316 23 483 478 480 489 +1317 26 473 490 491 492 +1318 27 473 490 491 495 +1319 28 473 490 491 496 +1320 29 494 490 491 492 +1321 30 494 490 491 495 +1322 31 494 490 491 496 +1323 32 490 491 492 493 +1324 33 490 491 492 507 +1325 34 490 491 496 497 +1326 35 490 491 496 501 +1327 35 490 491 496 502 +1328 8 492 491 496 497 +1329 9 492 491 496 501 +1330 9 492 491 496 502 +1331 10 495 491 492 493 +1332 11 495 491 492 507 +1333 12 495 491 496 497 +1334 13 495 491 496 501 +1335 13 495 491 496 502 +1336 14 496 491 492 493 +1337 15 496 491 492 507 +1338 16 491 492 507 508 +1339 17 491 492 507 511 +1340 18 493 492 507 508 +1341 19 493 492 507 511 +1342 36 491 496 497 498 +1343 21 491 496 497 503 +1344 21 491 496 497 504 +1345 37 501 496 497 498 +1346 23 501 496 497 503 +1347 23 501 496 497 504 +1348 37 502 496 497 498 +1349 23 502 496 497 503 +1350 23 502 496 497 504 +1351 38 496 497 498 499 +1352 39 496 497 498 500 +1353 40 503 497 498 499 +1354 41 503 497 498 500 +1355 40 504 497 498 499 +1356 41 504 497 498 500 +1357 42 497 498 500 505 +1358 42 497 498 500 506 +1359 19 499 498 500 505 +1360 19 499 498 500 506 +1361 26 492 507 508 509 +1362 27 492 507 508 512 +1363 28 492 507 508 513 +1364 29 511 507 508 509 +1365 30 511 507 508 512 +1366 31 511 507 508 513 +1367 32 507 508 509 510 +1368 33 507 508 509 519 +1369 141 507 508 513 514 +1370 35 507 508 513 517 +1371 35 507 508 513 518 +1372 142 509 508 513 514 +1373 9 509 508 513 517 +1374 9 509 508 513 518 +1375 10 512 508 509 510 +1376 11 512 508 509 519 +1377 143 512 508 513 514 +1378 13 512 508 513 517 +1379 13 512 508 513 518 +1380 14 513 508 509 510 +1381 15 513 508 509 519 +1382 16 508 509 519 520 +1383 17 508 509 519 523 +1384 18 510 509 519 520 +1385 19 510 509 519 523 +1386 144 508 513 514 515 +1387 144 508 513 514 516 +1388 100 517 513 514 515 +1389 100 517 513 514 516 +1390 100 518 513 514 515 +1391 100 518 513 514 516 +1392 26 509 519 520 521 +1393 27 509 519 520 524 +1394 28 509 519 520 525 +1395 29 523 519 520 521 +1396 30 523 519 520 524 +1397 31 523 519 520 525 +1398 32 519 520 521 522 +1399 33 519 520 521 541 +1400 34 519 520 525 526 +1401 35 519 520 525 530 +1402 35 519 520 525 531 +1403 8 521 520 525 526 +1404 9 521 520 525 530 +1405 9 521 520 525 531 +1406 10 524 520 521 522 +1407 11 524 520 521 541 +1408 12 524 520 525 526 +1409 13 524 520 525 530 +1410 13 524 520 525 531 +1411 14 525 520 521 522 +1412 15 525 520 521 541 +1413 16 520 521 541 542 +1414 17 520 521 541 545 +1415 18 522 521 541 542 +1416 19 522 521 541 545 +1417 67 520 525 526 527 +1418 21 520 525 526 532 +1419 21 520 525 526 533 +1420 68 530 525 526 527 +1421 23 530 525 526 532 +1422 23 530 525 526 533 +1423 68 531 525 526 527 +1424 23 531 525 526 532 +1425 23 531 525 526 533 +1426 69 525 526 527 528 +1427 68 525 526 527 534 +1428 68 525 526 527 535 +1429 68 532 526 527 528 +1430 23 532 526 527 534 +1431 23 532 526 527 535 +1432 68 533 526 527 528 +1433 23 533 526 527 534 +1434 23 533 526 527 535 +1435 70 526 527 528 529 +1436 68 526 527 528 536 +1437 68 526 527 528 537 +1438 71 534 527 528 529 +1439 23 534 527 528 536 +1440 23 534 527 528 537 +1441 71 535 527 528 529 +1442 23 535 527 528 536 +1443 23 535 527 528 537 +1444 72 527 528 529 538 +1445 72 527 528 529 539 +1446 72 527 528 529 540 +1447 73 536 528 529 538 +1448 73 536 528 529 539 +1449 73 536 528 529 540 +1450 73 537 528 529 538 +1451 73 537 528 529 539 +1452 73 537 528 529 540 +1453 26 521 541 542 543 +1454 27 521 541 542 546 +1455 28 521 541 542 547 +1456 29 545 541 542 543 +1457 30 545 541 542 546 +1458 31 545 541 542 547 +1459 32 541 542 543 544 +1460 33 541 542 543 556 +1461 34 541 542 547 548 +1462 35 541 542 547 552 +1463 35 541 542 547 553 +1464 8 543 542 547 548 +1465 9 543 542 547 552 +1466 9 543 542 547 553 +1467 10 546 542 543 544 +1468 11 546 542 543 556 +1469 12 546 542 547 548 +1470 13 546 542 547 552 +1471 13 546 542 547 553 +1472 14 547 542 543 544 +1473 15 547 542 543 556 +1474 85 542 543 556 557 +1475 17 542 543 556 560 +1476 86 544 543 556 557 +1477 19 544 543 556 560 +1478 97 542 547 548 549 +1479 21 542 547 548 554 +1480 21 542 547 548 555 +1481 98 552 547 548 549 +1482 23 552 547 548 554 +1483 23 552 547 548 555 +1484 98 553 547 548 549 +1485 23 553 547 548 554 +1486 23 553 547 548 555 +1487 99 547 548 549 550 +1488 99 547 548 549 551 +1489 100 554 548 549 550 +1490 100 554 548 549 551 +1491 100 555 548 549 550 +1492 100 555 548 549 551 +1493 87 543 556 557 558 +1494 88 543 556 557 561 +1495 88 543 556 557 562 +1496 89 560 556 557 558 +1497 90 560 556 557 561 +1498 90 560 556 557 562 +1499 91 556 557 558 559 +1500 92 556 557 558 563 +1501 93 561 557 558 559 +1502 94 561 557 558 563 +1503 93 562 557 558 559 +1504 94 562 557 558 563 +1505 95 557 558 563 564 +1506 96 557 558 563 567 +1507 18 559 558 563 564 +1508 19 559 558 563 567 +1509 26 558 563 564 565 +1510 27 558 563 564 568 +1511 43 558 563 564 569 +1512 29 567 563 564 565 +1513 30 567 563 564 568 +1514 44 567 563 564 569 +1515 32 563 564 565 566 +1516 101 563 564 565 582 +1517 45 563 564 569 570 +1518 45 563 564 569 571 +1519 46 563 564 569 573 +1520 47 565 564 569 570 +1521 47 565 564 569 571 +1522 48 565 564 569 573 +1523 10 568 564 565 566 +1524 102 568 564 565 582 +1525 49 568 564 569 570 +1526 49 568 564 569 571 +1527 50 568 564 569 573 +1528 51 569 564 565 566 +1529 150 569 564 565 582 +1530 104 564 565 582 583 +1531 105 564 565 582 589 +1532 106 566 565 582 583 +1533 107 566 565 582 589 +1534 53 564 569 570 572 +1535 54 564 569 570 574 +1536 54 564 569 570 575 +1537 54 564 569 571 576 +1538 54 564 569 571 577 +1539 54 564 569 571 578 +1540 55 570 569 571 576 +1541 55 570 569 571 577 +1542 55 570 569 571 578 +1543 56 571 569 570 572 +1544 55 571 569 570 574 +1545 55 571 569 570 575 +1546 12 573 569 570 572 +1547 13 573 569 570 574 +1548 13 573 569 570 575 +1549 13 573 569 571 576 +1550 13 573 569 571 577 +1551 13 573 569 571 578 +1552 21 569 570 572 579 +1553 21 569 570 572 580 +1554 21 569 570 572 581 +1555 23 574 570 572 579 +1556 23 574 570 572 580 +1557 23 574 570 572 581 +1558 23 575 570 572 579 +1559 23 575 570 572 580 +1560 23 575 570 572 581 +1561 108 565 582 583 584 +1562 109 565 582 583 586 +1563 110 565 582 583 587 +1564 111 565 582 589 588 +1565 112 565 582 589 594 +1566 112 565 582 589 595 +1567 113 583 582 589 588 +1568 114 583 582 589 594 +1569 114 583 582 589 595 +1570 115 589 582 583 584 +1571 116 589 582 583 586 +1572 117 589 582 583 587 +1573 118 582 583 584 585 +1574 151 582 583 584 596 +1575 120 582 583 587 588 +1576 121 582 583 587 590 +1577 121 582 583 587 591 +1578 122 584 583 587 588 +1579 123 584 583 587 590 +1580 123 584 583 587 591 +1581 10 586 583 584 585 +1582 102 586 583 584 596 +1583 124 586 583 587 588 +1584 125 586 583 587 590 +1585 125 586 583 587 591 +1586 126 587 583 584 585 +1587 152 587 583 584 596 +1588 104 583 584 596 597 +1589 105 583 584 596 603 +1590 106 585 584 596 597 +1591 107 585 584 596 603 +1592 128 583 587 588 589 +1593 129 583 587 588 592 +1594 129 583 587 588 593 +1595 130 590 587 588 589 +1596 131 590 587 588 592 +1597 131 590 587 588 593 +1598 130 591 587 588 589 +1599 131 591 587 588 592 +1600 131 591 587 588 593 +1601 132 587 588 589 582 +1602 133 587 588 589 594 +1603 133 587 588 589 595 +1604 134 592 588 589 582 +1605 135 592 588 589 594 +1606 135 592 588 589 595 +1607 134 593 588 589 582 +1608 135 593 588 589 594 +1609 135 593 588 589 595 +1610 108 584 596 597 598 +1611 109 584 596 597 600 +1612 110 584 596 597 601 +1613 111 584 596 603 602 +1614 112 584 596 603 608 +1615 112 584 596 603 609 +1616 113 597 596 603 602 +1617 114 597 596 603 608 +1618 114 597 596 603 609 +1619 115 603 596 597 598 +1620 116 603 596 597 600 +1621 117 603 596 597 601 +1622 118 596 597 598 599 +1623 119 596 597 598 610 +1624 120 596 597 601 602 +1625 121 596 597 601 604 +1626 121 596 597 601 605 +1627 122 598 597 601 602 +1628 123 598 597 601 604 +1629 123 598 597 601 605 +1630 10 600 597 598 599 +1631 11 600 597 598 610 +1632 124 600 597 601 602 +1633 125 600 597 601 604 +1634 125 600 597 601 605 +1635 126 601 597 598 599 +1636 127 601 597 598 610 +1637 16 597 598 610 611 +1638 17 597 598 610 614 +1639 18 599 598 610 611 +1640 19 599 598 610 614 +1641 128 597 601 602 603 +1642 129 597 601 602 606 +1643 129 597 601 602 607 +1644 130 604 601 602 603 +1645 131 604 601 602 606 +1646 131 604 601 602 607 +1647 130 605 601 602 603 +1648 131 605 601 602 606 +1649 131 605 601 602 607 +1650 132 601 602 603 596 +1651 133 601 602 603 608 +1652 133 601 602 603 609 +1653 134 606 602 603 596 +1654 135 606 602 603 608 +1655 135 606 602 603 609 +1656 134 607 602 603 596 +1657 135 607 602 603 608 +1658 135 607 602 603 609 +1659 26 598 610 611 612 +1660 27 598 610 611 615 +1661 28 598 610 611 616 +1662 29 614 610 611 612 +1663 30 614 610 611 615 +1664 31 614 610 611 616 +1665 32 610 611 612 613 +1666 33 610 611 612 622 +1667 141 610 611 616 617 +1668 35 610 611 616 620 +1669 35 610 611 616 621 +1670 142 612 611 616 617 +1671 9 612 611 616 620 +1672 9 612 611 616 621 +1673 10 615 611 612 613 +1674 11 615 611 612 622 +1675 143 615 611 616 617 +1676 13 615 611 616 620 +1677 13 615 611 616 621 +1678 14 616 611 612 613 +1679 15 616 611 612 622 +1680 16 611 612 622 623 +1681 17 611 612 622 626 +1682 18 613 612 622 623 +1683 19 613 612 622 626 +1684 144 611 616 617 618 +1685 144 611 616 617 619 +1686 100 620 616 617 618 +1687 100 620 616 617 619 +1688 100 621 616 617 618 +1689 100 621 616 617 619 +1690 26 612 622 623 624 +1691 27 612 622 623 627 +1692 28 612 622 623 628 +1693 29 626 622 623 624 +1694 30 626 622 623 627 +1695 31 626 622 623 628 +1696 32 622 623 624 625 +1697 33 622 623 624 639 +1698 34 622 623 628 629 +1699 35 622 623 628 633 +1700 35 622 623 628 634 +1701 8 624 623 628 629 +1702 9 624 623 628 633 +1703 9 624 623 628 634 +1704 10 627 623 624 625 +1705 11 627 623 624 639 +1706 12 627 623 628 629 +1707 13 627 623 628 633 +1708 13 627 623 628 634 +1709 14 628 623 624 625 +1710 15 628 623 624 639 +1711 16 623 624 639 640 +1712 17 623 624 639 643 +1713 18 625 624 639 640 +1714 19 625 624 639 643 +1715 36 623 628 629 630 +1716 21 623 628 629 635 +1717 21 623 628 629 636 +1718 37 633 628 629 630 +1719 23 633 628 629 635 +1720 23 633 628 629 636 +1721 37 634 628 629 630 +1722 23 634 628 629 635 +1723 23 634 628 629 636 +1724 38 628 629 630 631 +1725 39 628 629 630 632 +1726 40 635 629 630 631 +1727 41 635 629 630 632 +1728 40 636 629 630 631 +1729 41 636 629 630 632 +1730 42 629 630 632 637 +1731 42 629 630 632 638 +1732 19 631 630 632 637 +1733 19 631 630 632 638 +1734 26 624 639 640 641 +1735 27 624 639 640 644 +1736 28 624 639 640 645 +1737 29 643 639 640 641 +1738 30 643 639 640 644 +1739 31 643 639 640 645 +1740 32 639 640 641 642 +1741 33 639 640 641 656 +1742 34 639 640 645 646 +1743 35 639 640 645 650 +1744 35 639 640 645 651 +1745 8 641 640 645 646 +1746 9 641 640 645 650 +1747 9 641 640 645 651 +1748 10 644 640 641 642 +1749 11 644 640 641 656 +1750 12 644 640 645 646 +1751 13 644 640 645 650 +1752 13 644 640 645 651 +1753 14 645 640 641 642 +1754 15 645 640 641 656 +1755 16 640 641 656 657 +1756 17 640 641 656 660 +1757 18 642 641 656 657 +1758 19 642 641 656 660 +1759 36 640 645 646 647 +1760 21 640 645 646 652 +1761 21 640 645 646 653 +1762 37 650 645 646 647 +1763 23 650 645 646 652 +1764 23 650 645 646 653 +1765 37 651 645 646 647 +1766 23 651 645 646 652 +1767 23 651 645 646 653 +1768 38 645 646 647 648 +1769 39 645 646 647 649 +1770 40 652 646 647 648 +1771 41 652 646 647 649 +1772 40 653 646 647 648 +1773 41 653 646 647 649 +1774 42 646 647 649 654 +1775 42 646 647 649 655 +1776 19 648 647 649 654 +1777 19 648 647 649 655 +1778 26 641 656 657 658 +1779 27 641 656 657 661 +1780 28 641 656 657 662 +1781 29 660 656 657 658 +1782 30 660 656 657 661 +1783 31 660 656 657 662 +1784 32 656 657 658 659 +1785 33 656 657 658 680 +1786 34 656 657 662 663 +1787 35 656 657 662 669 +1788 35 656 657 662 670 +1789 8 658 657 662 663 +1790 9 658 657 662 669 +1791 9 658 657 662 670 +1792 10 661 657 658 659 +1793 11 661 657 658 680 +1794 12 661 657 662 663 +1795 13 661 657 662 669 +1796 13 661 657 662 670 +1797 14 662 657 658 659 +1798 15 662 657 658 680 +1799 16 657 658 680 681 +1800 17 657 658 680 684 +1801 18 659 658 680 681 +1802 19 659 658 680 684 +1803 67 657 662 663 664 +1804 21 657 662 663 671 +1805 21 657 662 663 672 +1806 68 669 662 663 664 +1807 23 669 662 663 671 +1808 23 669 662 663 672 +1809 68 670 662 663 664 +1810 23 670 662 663 671 +1811 23 670 662 663 672 +1812 153 662 663 664 665 +1813 68 662 663 664 673 +1814 68 662 663 664 674 +1815 154 671 663 664 665 +1816 23 671 663 664 673 +1817 23 671 663 664 674 +1818 154 672 663 664 665 +1819 23 672 663 664 673 +1820 23 672 663 664 674 +1821 155 663 664 665 666 +1822 156 663 664 665 675 +1823 157 673 664 665 666 +1824 158 673 664 665 675 +1825 157 674 664 665 666 +1826 158 674 664 665 675 +1827 159 664 665 666 667 +1828 159 664 665 666 668 +1829 160 675 665 666 667 +1830 160 675 665 666 668 +1831 160 665 666 667 676 +1832 160 665 666 667 677 +1833 160 665 666 668 678 +1834 160 665 666 668 679 +1835 160 667 666 668 678 +1836 160 667 666 668 679 +1837 160 668 666 667 676 +1838 160 668 666 667 677 +1839 26 658 680 681 682 +1840 27 658 680 681 685 +1841 28 658 680 681 686 +1842 29 684 680 681 682 +1843 30 684 680 681 685 +1844 31 684 680 681 686 +1845 32 680 681 682 683 +1846 33 680 681 682 699 +1847 81 680 681 686 687 +1848 35 680 681 686 690 +1849 35 680 681 686 691 +1850 82 682 681 686 687 +1851 9 682 681 686 690 +1852 9 682 681 686 691 +1853 10 685 681 682 683 +1854 11 685 681 682 699 +1855 83 685 681 686 687 +1856 13 685 681 686 690 +1857 13 685 681 686 691 +1858 14 686 681 682 683 +1859 15 686 681 682 699 +1860 16 681 682 699 700 +1861 17 681 682 699 703 +1862 18 683 682 699 700 +1863 19 683 682 699 703 +1864 84 681 686 687 688 +1865 84 681 686 687 689 +1866 83 681 686 687 692 +1867 55 690 686 687 688 +1868 55 690 686 687 689 +1869 13 690 686 687 692 +1870 55 691 686 687 688 +1871 55 691 686 687 689 +1872 13 691 686 687 692 +1873 55 686 687 688 693 +1874 55 686 687 688 694 +1875 55 686 687 688 695 +1876 55 686 687 689 696 +1877 55 686 687 689 697 +1878 55 686 687 689 698 +1879 55 688 687 689 696 +1880 55 688 687 689 697 +1881 55 688 687 689 698 +1882 55 689 687 688 693 +1883 55 689 687 688 694 +1884 55 689 687 688 695 +1885 13 692 687 688 693 +1886 13 692 687 688 694 +1887 13 692 687 688 695 +1888 13 692 687 689 696 +1889 13 692 687 689 697 +1890 13 692 687 689 698 +1891 26 682 699 700 701 +1892 27 682 699 700 704 +1893 43 682 699 700 705 +1894 29 703 699 700 701 +1895 30 703 699 700 704 +1896 44 703 699 700 705 +1897 32 699 700 701 702 +1898 33 699 700 701 718 +1899 45 699 700 705 706 +1900 45 699 700 705 707 +1901 46 699 700 705 709 +1902 47 701 700 705 706 +1903 47 701 700 705 707 +1904 48 701 700 705 709 +1905 10 704 700 701 702 +1906 11 704 700 701 718 +1907 49 704 700 705 706 +1908 49 704 700 705 707 +1909 50 704 700 705 709 +1910 51 705 700 701 702 +1911 52 705 700 701 718 +1912 16 700 701 718 719 +1913 17 700 701 718 722 +1914 18 702 701 718 719 +1915 19 702 701 718 722 +1916 53 700 705 706 708 +1917 54 700 705 706 710 +1918 54 700 705 706 711 +1919 54 700 705 707 712 +1920 54 700 705 707 713 +1921 54 700 705 707 714 +1922 55 706 705 707 712 +1923 55 706 705 707 713 +1924 55 706 705 707 714 +1925 56 707 705 706 708 +1926 55 707 705 706 710 +1927 55 707 705 706 711 +1928 12 709 705 706 708 +1929 13 709 705 706 710 +1930 13 709 705 706 711 +1931 13 709 705 707 712 +1932 13 709 705 707 713 +1933 13 709 705 707 714 +1934 21 705 706 708 715 +1935 21 705 706 708 716 +1936 21 705 706 708 717 +1937 23 710 706 708 715 +1938 23 710 706 708 716 +1939 23 710 706 708 717 +1940 23 711 706 708 715 +1941 23 711 706 708 716 +1942 23 711 706 708 717 +1943 26 701 718 719 720 +1944 27 701 718 719 723 +1945 28 701 718 719 724 +1946 29 722 718 719 720 +1947 30 722 718 719 723 +1948 31 722 718 719 724 +1949 32 718 719 720 721 +1950 33 718 719 720 738 +1951 57 718 719 724 725 +1952 35 718 719 724 731 +1953 35 718 719 724 732 +1954 58 720 719 724 725 +1955 9 720 719 724 731 +1956 9 720 719 724 732 +1957 10 723 719 720 721 +1958 11 723 719 720 738 +1959 59 723 719 724 725 +1960 13 723 719 724 731 +1961 13 723 719 724 732 +1962 14 724 719 720 721 +1963 15 724 719 720 738 +1964 16 719 720 738 739 +1965 17 719 720 738 742 +1966 18 721 720 738 739 +1967 19 721 720 738 742 +1968 60 719 724 725 726 +1969 60 719 724 725 727 +1970 61 731 724 725 726 +1971 61 731 724 725 727 +1972 61 732 724 725 726 +1973 61 732 724 725 727 +1974 62 724 725 726 728 +1975 63 724 725 726 733 +1976 62 724 725 727 729 +1977 63 724 725 727 734 +1978 64 726 725 727 729 +1979 65 726 725 727 734 +1980 64 727 725 726 728 +1981 65 727 725 726 733 +1982 64 725 726 728 730 +1983 65 725 726 728 735 +1984 65 733 726 728 730 +1985 66 733 726 728 735 +1986 64 725 727 729 730 +1987 65 725 727 729 736 +1988 65 734 727 729 730 +1989 66 734 727 729 736 +1990 64 726 728 730 729 +1991 65 726 728 730 737 +1992 65 735 728 730 729 +1993 66 735 728 730 737 +1994 64 727 729 730 728 +1995 65 727 729 730 737 +1996 65 736 729 730 728 +1997 66 736 729 730 737 +1998 26 720 738 739 740 +1999 27 720 738 739 743 +2000 28 720 738 739 744 +2001 29 742 738 739 740 +2002 30 742 738 739 743 +2003 31 742 738 739 744 +2004 32 738 739 740 741 +2005 33 738 739 740 748 +2006 35 738 739 744 745 +2007 35 738 739 744 746 +2008 35 738 739 744 747 +2009 9 740 739 744 745 +2010 9 740 739 744 746 +2011 9 740 739 744 747 +2012 10 743 739 740 741 +2013 11 743 739 740 748 +2014 13 743 739 744 745 +2015 13 743 739 744 746 +2016 13 743 739 744 747 +2017 14 744 739 740 741 +2018 15 744 739 740 748 +2019 85 739 740 748 749 +2020 17 739 740 748 752 +2021 86 741 740 748 749 +2022 19 741 740 748 752 +2023 87 740 748 749 750 +2024 88 740 748 749 753 +2025 88 740 748 749 754 +2026 89 752 748 749 750 +2027 90 752 748 749 753 +2028 90 752 748 749 754 +2029 91 748 749 750 751 +2030 92 748 749 750 755 +2031 93 753 749 750 751 +2032 94 753 749 750 755 +2033 93 754 749 750 751 +2034 94 754 749 750 755 +2035 95 749 750 755 756 +2036 96 749 750 755 759 +2037 18 751 750 755 756 +2038 19 751 750 755 759 +2039 26 750 755 756 757 +2040 27 750 755 756 760 +2041 28 750 755 756 761 +2042 29 759 755 756 757 +2043 30 759 755 756 760 +2044 31 759 755 756 761 +2045 32 755 756 757 758 +2046 33 755 756 757 777 +2047 34 755 756 761 762 +2048 35 755 756 761 766 +2049 35 755 756 761 767 +2050 8 757 756 761 762 +2051 9 757 756 761 766 +2052 9 757 756 761 767 +2053 10 760 756 757 758 +2054 11 760 756 757 777 +2055 12 760 756 761 762 +2056 13 760 756 761 766 +2057 13 760 756 761 767 +2058 14 761 756 757 758 +2059 15 761 756 757 777 +2060 16 756 757 777 778 +2061 17 756 757 777 781 +2062 18 758 757 777 778 +2063 19 758 757 777 781 +2064 67 756 761 762 763 +2065 21 756 761 762 768 +2066 21 756 761 762 769 +2067 68 766 761 762 763 +2068 23 766 761 762 768 +2069 23 766 761 762 769 +2070 68 767 761 762 763 +2071 23 767 761 762 768 +2072 23 767 761 762 769 +2073 69 761 762 763 764 +2074 68 761 762 763 770 +2075 68 761 762 763 771 +2076 68 768 762 763 764 +2077 23 768 762 763 770 +2078 23 768 762 763 771 +2079 68 769 762 763 764 +2080 23 769 762 763 770 +2081 23 769 762 763 771 +2082 70 762 763 764 765 +2083 68 762 763 764 772 +2084 68 762 763 764 773 +2085 71 770 763 764 765 +2086 23 770 763 764 772 +2087 23 770 763 764 773 +2088 71 771 763 764 765 +2089 23 771 763 764 772 +2090 23 771 763 764 773 +2091 72 763 764 765 774 +2092 72 763 764 765 775 +2093 72 763 764 765 776 +2094 73 772 764 765 774 +2095 73 772 764 765 775 +2096 73 772 764 765 776 +2097 73 773 764 765 774 +2098 73 773 764 765 775 +2099 73 773 764 765 776 +2100 26 757 777 778 779 +2101 27 757 777 778 782 +2102 28 757 777 778 783 +2103 29 781 777 778 779 +2104 30 781 777 778 782 +2105 31 781 777 778 783 +2106 32 777 778 779 780 +2107 33 777 778 779 794 +2108 34 777 778 783 784 +2109 35 777 778 783 788 +2110 35 777 778 783 789 +2111 8 779 778 783 784 +2112 9 779 778 783 788 +2113 9 779 778 783 789 +2114 10 782 778 779 780 +2115 11 782 778 779 794 +2116 12 782 778 783 784 +2117 13 782 778 783 788 +2118 13 782 778 783 789 +2119 14 783 778 779 780 +2120 15 783 778 779 794 +2121 16 778 779 794 795 +2122 17 778 779 794 798 +2123 18 780 779 794 795 +2124 19 780 779 794 798 +2125 36 778 783 784 785 +2126 21 778 783 784 790 +2127 21 778 783 784 791 +2128 37 788 783 784 785 +2129 23 788 783 784 790 +2130 23 788 783 784 791 +2131 37 789 783 784 785 +2132 23 789 783 784 790 +2133 23 789 783 784 791 +2134 38 783 784 785 786 +2135 39 783 784 785 787 +2136 40 790 784 785 786 +2137 41 790 784 785 787 +2138 40 791 784 785 786 +2139 41 791 784 785 787 +2140 42 784 785 787 792 +2141 42 784 785 787 793 +2142 19 786 785 787 792 +2143 19 786 785 787 793 +2144 26 779 794 795 796 +2145 27 779 794 795 799 +2146 28 779 794 795 800 +2147 29 798 794 795 796 +2148 30 798 794 795 799 +2149 31 798 794 795 800 +2150 32 794 795 796 797 +2151 33 794 795 796 813 +2152 81 794 795 800 801 +2153 35 794 795 800 804 +2154 35 794 795 800 805 +2155 82 796 795 800 801 +2156 9 796 795 800 804 +2157 9 796 795 800 805 +2158 10 799 795 796 797 +2159 11 799 795 796 813 +2160 83 799 795 800 801 +2161 13 799 795 800 804 +2162 13 799 795 800 805 +2163 14 800 795 796 797 +2164 15 800 795 796 813 +2165 16 795 796 813 814 +2166 17 795 796 813 817 +2167 18 797 796 813 814 +2168 19 797 796 813 817 +2169 84 795 800 801 802 +2170 84 795 800 801 803 +2171 83 795 800 801 806 +2172 55 804 800 801 802 +2173 55 804 800 801 803 +2174 13 804 800 801 806 +2175 55 805 800 801 802 +2176 55 805 800 801 803 +2177 13 805 800 801 806 +2178 55 800 801 802 807 +2179 55 800 801 802 808 +2180 55 800 801 802 809 +2181 55 800 801 803 810 +2182 55 800 801 803 811 +2183 55 800 801 803 812 +2184 55 802 801 803 810 +2185 55 802 801 803 811 +2186 55 802 801 803 812 +2187 55 803 801 802 807 +2188 55 803 801 802 808 +2189 55 803 801 802 809 +2190 13 806 801 802 807 +2191 13 806 801 802 808 +2192 13 806 801 802 809 +2193 13 806 801 803 810 +2194 13 806 801 803 811 +2195 13 806 801 803 812 +2196 26 796 813 814 815 +2197 27 796 813 814 818 +2198 28 796 813 814 819 +2199 29 817 813 814 815 +2200 30 817 813 814 818 +2201 31 817 813 814 819 +2202 32 813 814 815 816 +2203 33 813 814 815 828 +2204 34 813 814 819 820 +2205 35 813 814 819 824 +2206 35 813 814 819 825 +2207 8 815 814 819 820 +2208 9 815 814 819 824 +2209 9 815 814 819 825 +2210 10 818 814 815 816 +2211 11 818 814 815 828 +2212 12 818 814 819 820 +2213 13 818 814 819 824 +2214 13 818 814 819 825 +2215 14 819 814 815 816 +2216 15 819 814 815 828 +2217 16 814 815 828 829 +2218 17 814 815 828 832 +2219 18 816 815 828 829 +2220 19 816 815 828 832 +2221 97 814 819 820 821 +2222 21 814 819 820 826 +2223 21 814 819 820 827 +2224 98 824 819 820 821 +2225 23 824 819 820 826 +2226 23 824 819 820 827 +2227 98 825 819 820 821 +2228 23 825 819 820 826 +2229 23 825 819 820 827 +2230 99 819 820 821 822 +2231 99 819 820 821 823 +2232 100 826 820 821 822 +2233 100 826 820 821 823 +2234 100 827 820 821 822 +2235 100 827 820 821 823 +2236 26 815 828 829 830 +2237 27 815 828 829 833 +2238 28 815 828 829 834 +2239 29 832 828 829 830 +2240 30 832 828 829 833 +2241 31 832 828 829 834 +2242 32 828 829 830 831 +2243 33 828 829 830 840 +2244 141 828 829 834 835 +2245 35 828 829 834 838 +2246 35 828 829 834 839 +2247 142 830 829 834 835 +2248 9 830 829 834 838 +2249 9 830 829 834 839 +2250 10 833 829 830 831 +2251 11 833 829 830 840 +2252 143 833 829 834 835 +2253 13 833 829 834 838 +2254 13 833 829 834 839 +2255 14 834 829 830 831 +2256 15 834 829 830 840 +2257 85 829 830 840 841 +2258 17 829 830 840 844 +2259 86 831 830 840 841 +2260 19 831 830 840 844 +2261 144 829 834 835 836 +2262 144 829 834 835 837 +2263 100 838 834 835 836 +2264 100 838 834 835 837 +2265 100 839 834 835 836 +2266 100 839 834 835 837 +2267 87 830 840 841 842 +2268 88 830 840 841 845 +2269 88 830 840 841 846 +2270 89 844 840 841 842 +2271 90 844 840 841 845 +2272 90 844 840 841 846 +2273 91 840 841 842 843 +2274 92 840 841 842 847 +2275 93 845 841 842 843 +2276 94 845 841 842 847 +2277 93 846 841 842 843 +2278 94 846 841 842 847 +2279 95 841 842 847 848 +2280 96 841 842 847 851 +2281 18 843 842 847 848 +2282 19 843 842 847 851 +2283 26 842 847 848 849 +2284 27 842 847 848 852 +2285 28 842 847 848 853 +2286 29 851 847 848 849 +2287 30 851 847 848 852 +2288 31 851 847 848 853 +2289 32 847 848 849 850 +2290 33 847 848 849 871 +2291 34 847 848 853 854 +2292 35 847 848 853 860 +2293 35 847 848 853 861 +2294 8 849 848 853 854 +2295 9 849 848 853 860 +2296 9 849 848 853 861 +2297 10 852 848 849 850 +2298 11 852 848 849 871 +2299 12 852 848 853 854 +2300 13 852 848 853 860 +2301 13 852 848 853 861 +2302 14 853 848 849 850 +2303 15 853 848 849 871 +2304 16 848 849 871 872 +2305 17 848 849 871 875 +2306 18 850 849 871 872 +2307 19 850 849 871 875 +2308 67 848 853 854 855 +2309 21 848 853 854 862 +2310 21 848 853 854 863 +2311 68 860 853 854 855 +2312 23 860 853 854 862 +2313 23 860 853 854 863 +2314 68 861 853 854 855 +2315 23 861 853 854 862 +2316 23 861 853 854 863 +2317 153 853 854 855 856 +2318 68 853 854 855 864 +2319 68 853 854 855 865 +2320 154 862 854 855 856 +2321 23 862 854 855 864 +2322 23 862 854 855 865 +2323 154 863 854 855 856 +2324 23 863 854 855 864 +2325 23 863 854 855 865 +2326 155 854 855 856 857 +2327 156 854 855 856 866 +2328 157 864 855 856 857 +2329 158 864 855 856 866 +2330 157 865 855 856 857 +2331 158 865 855 856 866 +2332 159 855 856 857 858 +2333 159 855 856 857 859 +2334 160 866 856 857 858 +2335 160 866 856 857 859 +2336 160 856 857 858 867 +2337 160 856 857 858 868 +2338 160 856 857 859 869 +2339 160 856 857 859 870 +2340 160 858 857 859 869 +2341 160 858 857 859 870 +2342 160 859 857 858 867 +2343 160 859 857 858 868 +2344 26 849 871 872 873 +2345 27 849 871 872 876 +2346 43 849 871 872 877 +2347 29 875 871 872 873 +2348 30 875 871 872 876 +2349 44 875 871 872 877 +2350 32 871 872 873 874 +2351 33 871 872 873 885 +2352 74 871 872 877 878 +2353 45 871 872 877 879 +2354 46 871 872 877 880 +2355 75 873 872 877 878 +2356 47 873 872 877 879 +2357 48 873 872 877 880 +2358 10 876 872 873 874 +2359 11 876 872 873 885 +2360 76 876 872 877 878 +2361 49 876 872 877 879 +2362 50 876 872 877 880 +2363 51 877 872 873 874 +2364 52 877 872 873 885 +2365 16 872 873 885 886 +2366 17 872 873 885 889 +2367 18 874 873 885 886 +2368 19 874 873 885 889 +2369 77 872 877 878 881 +2370 54 872 877 879 882 +2371 54 872 877 879 883 +2372 54 872 877 879 884 +2373 78 878 877 879 882 +2374 78 878 877 879 883 +2375 78 878 877 879 884 +2376 79 879 877 878 881 +2377 80 880 877 878 881 +2378 13 880 877 879 882 +2379 13 880 877 879 883 +2380 13 880 877 879 884 +2381 26 873 885 886 887 +2382 27 873 885 886 890 +2383 28 873 885 886 891 +2384 29 889 885 886 887 +2385 30 889 885 886 890 +2386 31 889 885 886 891 +2387 32 885 886 887 888 +2388 33 885 886 887 904 +2389 81 885 886 891 892 +2390 35 885 886 891 895 +2391 35 885 886 891 896 +2392 82 887 886 891 892 +2393 9 887 886 891 895 +2394 9 887 886 891 896 +2395 10 890 886 887 888 +2396 11 890 886 887 904 +2397 83 890 886 891 892 +2398 13 890 886 891 895 +2399 13 890 886 891 896 +2400 14 891 886 887 888 +2401 15 891 886 887 904 +2402 16 886 887 904 905 +2403 17 886 887 904 908 +2404 18 888 887 904 905 +2405 19 888 887 904 908 +2406 84 886 891 892 893 +2407 84 886 891 892 894 +2408 83 886 891 892 897 +2409 55 895 891 892 893 +2410 55 895 891 892 894 +2411 13 895 891 892 897 +2412 55 896 891 892 893 +2413 55 896 891 892 894 +2414 13 896 891 892 897 +2415 55 891 892 893 898 +2416 55 891 892 893 899 +2417 55 891 892 893 900 +2418 55 891 892 894 901 +2419 55 891 892 894 902 +2420 55 891 892 894 903 +2421 55 893 892 894 901 +2422 55 893 892 894 902 +2423 55 893 892 894 903 +2424 55 894 892 893 898 +2425 55 894 892 893 899 +2426 55 894 892 893 900 +2427 13 897 892 893 898 +2428 13 897 892 893 899 +2429 13 897 892 893 900 +2430 13 897 892 894 901 +2431 13 897 892 894 902 +2432 13 897 892 894 903 +2433 26 887 904 905 906 +2434 27 887 904 905 909 +2435 28 887 904 905 910 +2436 29 908 904 905 906 +2437 30 908 904 905 909 +2438 31 908 904 905 910 +2439 32 904 905 906 907 +2440 33 904 905 906 915 +2441 136 904 905 910 911 +2442 35 904 905 910 912 +2443 35 904 905 910 913 +2444 137 906 905 910 911 +2445 9 906 905 910 912 +2446 9 906 905 910 913 +2447 10 909 905 906 907 +2448 11 909 905 906 915 +2449 138 909 905 910 911 +2450 13 909 905 910 912 +2451 13 909 905 910 913 +2452 14 910 905 906 907 +2453 15 910 905 906 915 +2454 16 905 906 915 916 +2455 17 905 906 915 919 +2456 18 907 906 915 916 +2457 19 907 906 915 919 +2458 139 905 910 911 914 +2459 140 912 910 911 914 +2460 140 913 910 911 914 +2461 26 906 915 916 917 +2462 27 906 915 916 920 +2463 28 906 915 916 921 +2464 29 919 915 916 917 +2465 30 919 915 916 920 +2466 31 919 915 916 921 +2467 32 915 916 917 918 +2468 33 915 916 917 927 +2469 141 915 916 921 922 +2470 35 915 916 921 925 +2471 35 915 916 921 926 +2472 142 917 916 921 922 +2473 9 917 916 921 925 +2474 9 917 916 921 926 +2475 10 920 916 917 918 +2476 11 920 916 917 927 +2477 143 920 916 921 922 +2478 13 920 916 921 925 +2479 13 920 916 921 926 +2480 14 921 916 917 918 +2481 15 921 916 917 927 +2482 16 916 917 927 928 +2483 17 916 917 927 931 +2484 18 918 917 927 928 +2485 19 918 917 927 931 +2486 144 916 921 922 923 +2487 144 916 921 922 924 +2488 100 925 921 922 923 +2489 100 925 921 922 924 +2490 100 926 921 922 923 +2491 100 926 921 922 924 +2492 26 917 927 928 929 +2493 27 917 927 928 932 +2494 28 917 927 928 933 +2495 29 931 927 928 929 +2496 30 931 927 928 932 +2497 31 931 927 928 933 +2498 32 927 928 929 930 +2499 33 927 928 929 948 +2500 57 927 928 933 934 +2501 35 927 928 933 941 +2502 35 927 928 933 942 +2503 58 929 928 933 934 +2504 9 929 928 933 941 +2505 9 929 928 933 942 +2506 10 932 928 929 930 +2507 11 932 928 929 948 +2508 59 932 928 933 934 +2509 13 932 928 933 941 +2510 13 932 928 933 942 +2511 14 933 928 929 930 +2512 15 933 928 929 948 +2513 16 928 929 948 949 +2514 17 928 929 948 952 +2515 18 930 929 948 949 +2516 19 930 929 948 952 +2517 60 928 933 934 935 +2518 60 928 933 934 936 +2519 61 941 933 934 935 +2520 61 941 933 934 936 +2521 61 942 933 934 935 +2522 61 942 933 934 936 +2523 62 933 934 935 937 +2524 63 933 934 935 943 +2525 62 933 934 936 938 +2526 63 933 934 936 944 +2527 64 935 934 936 938 +2528 65 935 934 936 944 +2529 64 936 934 935 937 +2530 65 936 934 935 943 +2531 64 934 935 937 939 +2532 65 934 935 937 945 +2533 65 943 935 937 939 +2534 66 943 935 937 945 +2535 64 934 936 938 939 +2536 65 934 936 938 946 +2537 65 944 936 938 939 +2538 66 944 936 938 946 +2539 64 935 937 939 938 +2540 161 935 937 939 940 +2541 65 945 937 939 938 +2542 162 945 937 939 940 +2543 64 936 938 939 937 +2544 161 936 938 939 940 +2545 65 946 938 939 937 +2546 162 946 938 939 940 +2547 163 937 939 940 947 +2548 163 938 939 940 947 +2549 26 929 948 949 950 +2550 27 929 948 949 953 +2551 28 929 948 949 954 +2552 29 952 948 949 950 +2553 30 952 948 949 953 +2554 31 952 948 949 954 +2555 32 948 949 950 951 +2556 33 948 949 950 962 +2557 145 948 949 954 955 +2558 35 948 949 954 958 +2559 35 948 949 954 959 +2560 146 950 949 954 955 +2561 9 950 949 954 958 +2562 9 950 949 954 959 +2563 10 953 949 950 951 +2564 11 953 949 950 962 +2565 147 953 949 954 955 +2566 13 953 949 954 958 +2567 13 953 949 954 959 +2568 14 954 949 950 951 +2569 15 954 949 950 962 +2570 16 949 950 962 963 +2571 17 949 950 962 966 +2572 18 951 950 962 963 +2573 19 951 950 962 966 +2574 148 949 954 955 956 +2575 149 949 954 955 957 +2576 40 958 954 955 956 +2577 41 958 954 955 957 +2578 40 959 954 955 956 +2579 41 959 954 955 957 +2580 42 954 955 957 960 +2581 42 954 955 957 961 +2582 19 956 955 957 960 +2583 19 956 955 957 961 +2584 26 950 962 963 964 +2585 27 950 962 963 967 +2586 43 950 962 963 968 +2587 29 966 962 963 964 +2588 30 966 962 963 967 +2589 44 966 962 963 968 +2590 32 962 963 964 965 +2591 33 962 963 964 981 +2592 45 962 963 968 969 +2593 45 962 963 968 970 +2594 46 962 963 968 972 +2595 47 964 963 968 969 +2596 47 964 963 968 970 +2597 48 964 963 968 972 +2598 10 967 963 964 965 +2599 11 967 963 964 981 +2600 49 967 963 968 969 +2601 49 967 963 968 970 +2602 50 967 963 968 972 +2603 51 968 963 964 965 +2604 52 968 963 964 981 +2605 16 963 964 981 982 +2606 17 963 964 981 985 +2607 18 965 964 981 982 +2608 19 965 964 981 985 +2609 53 963 968 969 971 +2610 54 963 968 969 973 +2611 54 963 968 969 974 +2612 54 963 968 970 975 +2613 54 963 968 970 976 +2614 54 963 968 970 977 +2615 55 969 968 970 975 +2616 55 969 968 970 976 +2617 55 969 968 970 977 +2618 56 970 968 969 971 +2619 55 970 968 969 973 +2620 55 970 968 969 974 +2621 12 972 968 969 971 +2622 13 972 968 969 973 +2623 13 972 968 969 974 +2624 13 972 968 970 975 +2625 13 972 968 970 976 +2626 13 972 968 970 977 +2627 21 968 969 971 978 +2628 21 968 969 971 979 +2629 21 968 969 971 980 +2630 23 973 969 971 978 +2631 23 973 969 971 979 +2632 23 973 969 971 980 +2633 23 974 969 971 978 +2634 23 974 969 971 979 +2635 23 974 969 971 980 +2636 26 964 981 982 983 +2637 27 964 981 982 986 +2638 28 964 981 982 987 +2639 29 985 981 982 983 +2640 30 985 981 982 986 +2641 31 985 981 982 987 +2642 32 981 982 983 984 +2643 33 981 982 983 998 +2644 34 981 982 987 988 +2645 35 981 982 987 992 +2646 35 981 982 987 993 +2647 8 983 982 987 988 +2648 9 983 982 987 992 +2649 9 983 982 987 993 +2650 10 986 982 983 984 +2651 11 986 982 983 998 +2652 12 986 982 987 988 +2653 13 986 982 987 992 +2654 13 986 982 987 993 +2655 14 987 982 983 984 +2656 15 987 982 983 998 +2657 16 982 983 998 999 +2658 17 982 983 998 1002 +2659 18 984 983 998 999 +2660 19 984 983 998 1002 +2661 36 982 987 988 989 +2662 21 982 987 988 994 +2663 21 982 987 988 995 +2664 37 992 987 988 989 +2665 23 992 987 988 994 +2666 23 992 987 988 995 +2667 37 993 987 988 989 +2668 23 993 987 988 994 +2669 23 993 987 988 995 +2670 38 987 988 989 990 +2671 39 987 988 989 991 +2672 40 994 988 989 990 +2673 41 994 988 989 991 +2674 40 995 988 989 990 +2675 41 995 988 989 991 +2676 42 988 989 991 996 +2677 42 988 989 991 997 +2678 19 990 989 991 996 +2679 19 990 989 991 997 +2680 26 983 998 999 1000 +2681 27 983 998 999 1003 +2682 28 983 998 999 1004 +2683 29 1002 998 999 1000 +2684 30 1002 998 999 1003 +2685 31 1002 998 999 1004 +2686 32 998 999 1000 1001 +2687 33 998 999 1000 1020 +2688 34 998 999 1004 1005 +2689 35 998 999 1004 1009 +2690 35 998 999 1004 1010 +2691 8 1000 999 1004 1005 +2692 9 1000 999 1004 1009 +2693 9 1000 999 1004 1010 +2694 10 1003 999 1000 1001 +2695 11 1003 999 1000 1020 +2696 12 1003 999 1004 1005 +2697 13 1003 999 1004 1009 +2698 13 1003 999 1004 1010 +2699 14 1004 999 1000 1001 +2700 15 1004 999 1000 1020 +2701 16 999 1000 1020 1021 +2702 17 999 1000 1020 1024 +2703 18 1001 1000 1020 1021 +2704 19 1001 1000 1020 1024 +2705 67 999 1004 1005 1006 +2706 21 999 1004 1005 1011 +2707 21 999 1004 1005 1012 +2708 68 1009 1004 1005 1006 +2709 23 1009 1004 1005 1011 +2710 23 1009 1004 1005 1012 +2711 68 1010 1004 1005 1006 +2712 23 1010 1004 1005 1011 +2713 23 1010 1004 1005 1012 +2714 69 1004 1005 1006 1007 +2715 68 1004 1005 1006 1013 +2716 68 1004 1005 1006 1014 +2717 68 1011 1005 1006 1007 +2718 23 1011 1005 1006 1013 +2719 23 1011 1005 1006 1014 +2720 68 1012 1005 1006 1007 +2721 23 1012 1005 1006 1013 +2722 23 1012 1005 1006 1014 +2723 70 1005 1006 1007 1008 +2724 68 1005 1006 1007 1015 +2725 68 1005 1006 1007 1016 +2726 71 1013 1006 1007 1008 +2727 23 1013 1006 1007 1015 +2728 23 1013 1006 1007 1016 +2729 71 1014 1006 1007 1008 +2730 23 1014 1006 1007 1015 +2731 23 1014 1006 1007 1016 +2732 72 1006 1007 1008 1017 +2733 72 1006 1007 1008 1018 +2734 72 1006 1007 1008 1019 +2735 73 1015 1007 1008 1017 +2736 73 1015 1007 1008 1018 +2737 73 1015 1007 1008 1019 +2738 73 1016 1007 1008 1017 +2739 73 1016 1007 1008 1018 +2740 73 1016 1007 1008 1019 +2741 26 1000 1020 1021 1022 +2742 27 1000 1020 1021 1025 +2743 28 1000 1020 1021 1026 +2744 29 1024 1020 1021 1022 +2745 30 1024 1020 1021 1025 +2746 31 1024 1020 1021 1026 +2747 32 1020 1021 1022 1023 +2748 33 1020 1021 1022 1035 +2749 34 1020 1021 1026 1027 +2750 35 1020 1021 1026 1031 +2751 35 1020 1021 1026 1032 +2752 8 1022 1021 1026 1027 +2753 9 1022 1021 1026 1031 +2754 9 1022 1021 1026 1032 +2755 10 1025 1021 1022 1023 +2756 11 1025 1021 1022 1035 +2757 12 1025 1021 1026 1027 +2758 13 1025 1021 1026 1031 +2759 13 1025 1021 1026 1032 +2760 14 1026 1021 1022 1023 +2761 15 1026 1021 1022 1035 +2762 16 1021 1022 1035 1036 +2763 17 1021 1022 1035 1039 +2764 18 1023 1022 1035 1036 +2765 19 1023 1022 1035 1039 +2766 97 1021 1026 1027 1028 +2767 21 1021 1026 1027 1033 +2768 21 1021 1026 1027 1034 +2769 98 1031 1026 1027 1028 +2770 23 1031 1026 1027 1033 +2771 23 1031 1026 1027 1034 +2772 98 1032 1026 1027 1028 +2773 23 1032 1026 1027 1033 +2774 23 1032 1026 1027 1034 +2775 99 1026 1027 1028 1029 +2776 99 1026 1027 1028 1030 +2777 100 1033 1027 1028 1029 +2778 100 1033 1027 1028 1030 +2779 100 1034 1027 1028 1029 +2780 100 1034 1027 1028 1030 +2781 26 1022 1035 1036 1037 +2782 27 1022 1035 1036 1040 +2783 28 1022 1035 1036 1041 +2784 29 1039 1035 1036 1037 +2785 30 1039 1035 1036 1040 +2786 31 1039 1035 1036 1041 +2787 32 1035 1036 1037 1038 +2788 33 1035 1036 1037 1046 +2789 136 1035 1036 1041 1042 +2790 35 1035 1036 1041 1043 +2791 35 1035 1036 1041 1044 +2792 137 1037 1036 1041 1042 +2793 9 1037 1036 1041 1043 +2794 9 1037 1036 1041 1044 +2795 10 1040 1036 1037 1038 +2796 11 1040 1036 1037 1046 +2797 138 1040 1036 1041 1042 +2798 13 1040 1036 1041 1043 +2799 13 1040 1036 1041 1044 +2800 14 1041 1036 1037 1038 +2801 15 1041 1036 1037 1046 +2802 16 1036 1037 1046 1047 +2803 17 1036 1037 1046 1050 +2804 18 1038 1037 1046 1047 +2805 19 1038 1037 1046 1050 +2806 139 1036 1041 1042 1045 +2807 140 1043 1041 1042 1045 +2808 140 1044 1041 1042 1045 +2809 26 1037 1046 1047 1048 +2810 27 1037 1046 1047 1051 +2811 43 1037 1046 1047 1052 +2812 29 1050 1046 1047 1048 +2813 30 1050 1046 1047 1051 +2814 44 1050 1046 1047 1052 +2815 32 1046 1047 1048 1049 +2816 33 1046 1047 1048 1060 +2817 74 1046 1047 1052 1053 +2818 45 1046 1047 1052 1054 +2819 46 1046 1047 1052 1055 +2820 75 1048 1047 1052 1053 +2821 47 1048 1047 1052 1054 +2822 48 1048 1047 1052 1055 +2823 10 1051 1047 1048 1049 +2824 11 1051 1047 1048 1060 +2825 76 1051 1047 1052 1053 +2826 49 1051 1047 1052 1054 +2827 50 1051 1047 1052 1055 +2828 51 1052 1047 1048 1049 +2829 52 1052 1047 1048 1060 +2830 16 1047 1048 1060 1061 +2831 17 1047 1048 1060 1064 +2832 18 1049 1048 1060 1061 +2833 19 1049 1048 1060 1064 +2834 77 1047 1052 1053 1056 +2835 54 1047 1052 1054 1057 +2836 54 1047 1052 1054 1058 +2837 54 1047 1052 1054 1059 +2838 78 1053 1052 1054 1057 +2839 78 1053 1052 1054 1058 +2840 78 1053 1052 1054 1059 +2841 79 1054 1052 1053 1056 +2842 80 1055 1052 1053 1056 +2843 13 1055 1052 1054 1057 +2844 13 1055 1052 1054 1058 +2845 13 1055 1052 1054 1059 +2846 26 1048 1060 1061 1062 +2847 27 1048 1060 1061 1065 +2848 28 1048 1060 1061 1066 +2849 29 1064 1060 1061 1062 +2850 30 1064 1060 1061 1065 +2851 31 1064 1060 1061 1066 +2852 32 1060 1061 1062 1063 +2853 33 1060 1061 1062 1079 +2854 81 1060 1061 1066 1067 +2855 35 1060 1061 1066 1070 +2856 35 1060 1061 1066 1071 +2857 82 1062 1061 1066 1067 +2858 9 1062 1061 1066 1070 +2859 9 1062 1061 1066 1071 +2860 10 1065 1061 1062 1063 +2861 11 1065 1061 1062 1079 +2862 83 1065 1061 1066 1067 +2863 13 1065 1061 1066 1070 +2864 13 1065 1061 1066 1071 +2865 14 1066 1061 1062 1063 +2866 15 1066 1061 1062 1079 +2867 16 1061 1062 1079 1080 +2868 17 1061 1062 1079 1083 +2869 18 1063 1062 1079 1080 +2870 19 1063 1062 1079 1083 +2871 84 1061 1066 1067 1068 +2872 84 1061 1066 1067 1069 +2873 83 1061 1066 1067 1072 +2874 55 1070 1066 1067 1068 +2875 55 1070 1066 1067 1069 +2876 13 1070 1066 1067 1072 +2877 55 1071 1066 1067 1068 +2878 55 1071 1066 1067 1069 +2879 13 1071 1066 1067 1072 +2880 55 1066 1067 1068 1073 +2881 55 1066 1067 1068 1074 +2882 55 1066 1067 1068 1075 +2883 55 1066 1067 1069 1076 +2884 55 1066 1067 1069 1077 +2885 55 1066 1067 1069 1078 +2886 55 1068 1067 1069 1076 +2887 55 1068 1067 1069 1077 +2888 55 1068 1067 1069 1078 +2889 55 1069 1067 1068 1073 +2890 55 1069 1067 1068 1074 +2891 55 1069 1067 1068 1075 +2892 13 1072 1067 1068 1073 +2893 13 1072 1067 1068 1074 +2894 13 1072 1067 1068 1075 +2895 13 1072 1067 1069 1076 +2896 13 1072 1067 1069 1077 +2897 13 1072 1067 1069 1078 +2898 26 1062 1079 1080 1081 +2899 27 1062 1079 1080 1084 +2900 28 1062 1079 1080 1085 +2901 29 1083 1079 1080 1081 +2902 30 1083 1079 1080 1084 +2903 31 1083 1079 1080 1085 +2904 32 1079 1080 1081 1082 +2905 33 1079 1080 1081 1097 +2906 164 1079 1080 1085 1086 +2907 35 1079 1080 1085 1091 +2908 35 1079 1080 1085 1092 +2909 165 1081 1080 1085 1086 +2910 9 1081 1080 1085 1091 +2911 9 1081 1080 1085 1092 +2912 10 1084 1080 1081 1082 +2913 11 1084 1080 1081 1097 +2914 166 1084 1080 1085 1086 +2915 13 1084 1080 1085 1091 +2916 13 1084 1080 1085 1092 +2917 14 1085 1080 1081 1082 +2918 15 1085 1080 1081 1097 +2919 16 1080 1081 1097 1098 +2920 17 1080 1081 1097 1101 +2921 18 1082 1081 1097 1098 +2922 19 1082 1081 1097 1101 +2923 167 1080 1085 1086 1087 +2924 168 1080 1085 1086 1088 +2925 169 1091 1085 1086 1087 +2926 170 1091 1085 1086 1088 +2927 169 1092 1085 1086 1087 +2928 170 1092 1085 1086 1088 +2929 171 1085 1086 1087 1089 +2930 172 1085 1086 1087 1093 +2931 173 1085 1086 1088 1090 +2932 174 1085 1086 1088 1094 +2933 175 1087 1086 1088 1090 +2934 176 1087 1086 1088 1094 +2935 177 1088 1086 1087 1089 +2936 178 1088 1086 1087 1093 +2937 179 1086 1087 1089 1090 +2938 180 1086 1087 1089 1095 +2939 181 1093 1087 1089 1090 +2940 182 1093 1087 1089 1095 +2941 177 1086 1088 1090 1089 +2942 178 1086 1088 1090 1096 +2943 183 1094 1088 1090 1089 +2944 184 1094 1088 1090 1096 +2945 179 1087 1089 1090 1088 +2946 181 1087 1089 1090 1096 +2947 180 1095 1089 1090 1088 +2948 182 1095 1089 1090 1096 +2949 26 1081 1097 1098 1099 +2950 27 1081 1097 1098 1102 +2951 28 1081 1097 1098 1103 +2952 29 1101 1097 1098 1099 +2953 30 1101 1097 1098 1102 +2954 31 1101 1097 1098 1103 +2955 32 1097 1098 1099 1100 +2956 33 1097 1098 1099 1116 +2957 81 1097 1098 1103 1104 +2958 35 1097 1098 1103 1107 +2959 35 1097 1098 1103 1108 +2960 82 1099 1098 1103 1104 +2961 9 1099 1098 1103 1107 +2962 9 1099 1098 1103 1108 +2963 10 1102 1098 1099 1100 +2964 11 1102 1098 1099 1116 +2965 83 1102 1098 1103 1104 +2966 13 1102 1098 1103 1107 +2967 13 1102 1098 1103 1108 +2968 14 1103 1098 1099 1100 +2969 15 1103 1098 1099 1116 +2970 16 1098 1099 1116 1117 +2971 17 1098 1099 1116 1120 +2972 18 1100 1099 1116 1117 +2973 19 1100 1099 1116 1120 +2974 84 1098 1103 1104 1105 +2975 84 1098 1103 1104 1106 +2976 83 1098 1103 1104 1109 +2977 55 1107 1103 1104 1105 +2978 55 1107 1103 1104 1106 +2979 13 1107 1103 1104 1109 +2980 55 1108 1103 1104 1105 +2981 55 1108 1103 1104 1106 +2982 13 1108 1103 1104 1109 +2983 55 1103 1104 1105 1110 +2984 55 1103 1104 1105 1111 +2985 55 1103 1104 1105 1112 +2986 55 1103 1104 1106 1113 +2987 55 1103 1104 1106 1114 +2988 55 1103 1104 1106 1115 +2989 55 1105 1104 1106 1113 +2990 55 1105 1104 1106 1114 +2991 55 1105 1104 1106 1115 +2992 55 1106 1104 1105 1110 +2993 55 1106 1104 1105 1111 +2994 55 1106 1104 1105 1112 +2995 13 1109 1104 1105 1110 +2996 13 1109 1104 1105 1111 +2997 13 1109 1104 1105 1112 +2998 13 1109 1104 1106 1113 +2999 13 1109 1104 1106 1114 +3000 13 1109 1104 1106 1115 +3001 26 1099 1116 1117 1118 +3002 27 1099 1116 1117 1121 +3003 43 1099 1116 1117 1122 +3004 29 1120 1116 1117 1118 +3005 30 1120 1116 1117 1121 +3006 44 1120 1116 1117 1122 +3007 32 1116 1117 1118 1119 +3008 33 1116 1117 1118 1132 +3009 45 1116 1117 1122 1123 +3010 45 1116 1117 1122 1124 +3011 46 1116 1117 1122 1125 +3012 47 1118 1117 1122 1123 +3013 47 1118 1117 1122 1124 +3014 48 1118 1117 1122 1125 +3015 10 1121 1117 1118 1119 +3016 11 1121 1117 1118 1132 +3017 49 1121 1117 1122 1123 +3018 49 1121 1117 1122 1124 +3019 50 1121 1117 1122 1125 +3020 51 1122 1117 1118 1119 +3021 52 1122 1117 1118 1132 +3022 16 1117 1118 1132 1133 +3023 17 1117 1118 1132 1136 +3024 18 1119 1118 1132 1133 +3025 19 1119 1118 1132 1136 +3026 54 1117 1122 1123 1126 +3027 54 1117 1122 1123 1127 +3028 54 1117 1122 1123 1128 +3029 54 1117 1122 1124 1129 +3030 54 1117 1122 1124 1130 +3031 54 1117 1122 1124 1131 +3032 55 1123 1122 1124 1129 +3033 55 1123 1122 1124 1130 +3034 55 1123 1122 1124 1131 +3035 55 1124 1122 1123 1126 +3036 55 1124 1122 1123 1127 +3037 55 1124 1122 1123 1128 +3038 13 1125 1122 1123 1126 +3039 13 1125 1122 1123 1127 +3040 13 1125 1122 1123 1128 +3041 13 1125 1122 1124 1129 +3042 13 1125 1122 1124 1130 +3043 13 1125 1122 1124 1131 +3044 26 1118 1132 1133 1134 +3045 27 1118 1132 1133 1137 +3046 28 1118 1132 1133 1138 +3047 29 1136 1132 1133 1134 +3048 30 1136 1132 1133 1137 +3049 31 1136 1132 1133 1138 +3050 32 1132 1133 1134 1135 +3051 33 1132 1133 1134 1151 +3052 81 1132 1133 1138 1139 +3053 35 1132 1133 1138 1142 +3054 35 1132 1133 1138 1143 +3055 82 1134 1133 1138 1139 +3056 9 1134 1133 1138 1142 +3057 9 1134 1133 1138 1143 +3058 10 1137 1133 1134 1135 +3059 11 1137 1133 1134 1151 +3060 83 1137 1133 1138 1139 +3061 13 1137 1133 1138 1142 +3062 13 1137 1133 1138 1143 +3063 14 1138 1133 1134 1135 +3064 15 1138 1133 1134 1151 +3065 16 1133 1134 1151 1152 +3066 17 1133 1134 1151 1155 +3067 18 1135 1134 1151 1152 +3068 19 1135 1134 1151 1155 +3069 84 1133 1138 1139 1140 +3070 84 1133 1138 1139 1141 +3071 83 1133 1138 1139 1144 +3072 55 1142 1138 1139 1140 +3073 55 1142 1138 1139 1141 +3074 13 1142 1138 1139 1144 +3075 55 1143 1138 1139 1140 +3076 55 1143 1138 1139 1141 +3077 13 1143 1138 1139 1144 +3078 55 1138 1139 1140 1145 +3079 55 1138 1139 1140 1146 +3080 55 1138 1139 1140 1147 +3081 55 1138 1139 1141 1148 +3082 55 1138 1139 1141 1149 +3083 55 1138 1139 1141 1150 +3084 55 1140 1139 1141 1148 +3085 55 1140 1139 1141 1149 +3086 55 1140 1139 1141 1150 +3087 55 1141 1139 1140 1145 +3088 55 1141 1139 1140 1146 +3089 55 1141 1139 1140 1147 +3090 13 1144 1139 1140 1145 +3091 13 1144 1139 1140 1146 +3092 13 1144 1139 1140 1147 +3093 13 1144 1139 1141 1148 +3094 13 1144 1139 1141 1149 +3095 13 1144 1139 1141 1150 +3096 26 1134 1151 1152 1153 +3097 27 1134 1151 1152 1156 +3098 28 1134 1151 1152 1157 +3099 29 1155 1151 1152 1153 +3100 30 1155 1151 1152 1156 +3101 31 1155 1151 1152 1157 +3102 32 1151 1152 1153 1154 +3103 33 1151 1152 1153 1175 +3104 34 1151 1152 1157 1158 +3105 35 1151 1152 1157 1164 +3106 35 1151 1152 1157 1165 +3107 8 1153 1152 1157 1158 +3108 9 1153 1152 1157 1164 +3109 9 1153 1152 1157 1165 +3110 10 1156 1152 1153 1154 +3111 11 1156 1152 1153 1175 +3112 12 1156 1152 1157 1158 +3113 13 1156 1152 1157 1164 +3114 13 1156 1152 1157 1165 +3115 14 1157 1152 1153 1154 +3116 15 1157 1152 1153 1175 +3117 16 1152 1153 1175 1176 +3118 17 1152 1153 1175 1179 +3119 18 1154 1153 1175 1176 +3120 19 1154 1153 1175 1179 +3121 67 1152 1157 1158 1159 +3122 21 1152 1157 1158 1166 +3123 21 1152 1157 1158 1167 +3124 68 1164 1157 1158 1159 +3125 23 1164 1157 1158 1166 +3126 23 1164 1157 1158 1167 +3127 68 1165 1157 1158 1159 +3128 23 1165 1157 1158 1166 +3129 23 1165 1157 1158 1167 +3130 153 1157 1158 1159 1160 +3131 68 1157 1158 1159 1168 +3132 68 1157 1158 1159 1169 +3133 154 1166 1158 1159 1160 +3134 23 1166 1158 1159 1168 +3135 23 1166 1158 1159 1169 +3136 154 1167 1158 1159 1160 +3137 23 1167 1158 1159 1168 +3138 23 1167 1158 1159 1169 +3139 155 1158 1159 1160 1161 +3140 156 1158 1159 1160 1170 +3141 157 1168 1159 1160 1161 +3142 158 1168 1159 1160 1170 +3143 157 1169 1159 1160 1161 +3144 158 1169 1159 1160 1170 +3145 159 1159 1160 1161 1162 +3146 159 1159 1160 1161 1163 +3147 160 1170 1160 1161 1162 +3148 160 1170 1160 1161 1163 +3149 160 1160 1161 1162 1171 +3150 160 1160 1161 1162 1172 +3151 160 1160 1161 1163 1173 +3152 160 1160 1161 1163 1174 +3153 160 1162 1161 1163 1173 +3154 160 1162 1161 1163 1174 +3155 160 1163 1161 1162 1171 +3156 160 1163 1161 1162 1172 +3157 26 1153 1175 1176 1177 +3158 27 1153 1175 1176 1180 +3159 28 1153 1175 1176 1181 +3160 29 1179 1175 1176 1177 +3161 30 1179 1175 1176 1180 +3162 31 1179 1175 1176 1181 +3163 32 1175 1176 1177 1178 +3164 33 1175 1176 1177 1194 +3165 81 1175 1176 1181 1182 +3166 35 1175 1176 1181 1185 +3167 35 1175 1176 1181 1186 +3168 82 1177 1176 1181 1182 +3169 9 1177 1176 1181 1185 +3170 9 1177 1176 1181 1186 +3171 10 1180 1176 1177 1178 +3172 11 1180 1176 1177 1194 +3173 83 1180 1176 1181 1182 +3174 13 1180 1176 1181 1185 +3175 13 1180 1176 1181 1186 +3176 14 1181 1176 1177 1178 +3177 15 1181 1176 1177 1194 +3178 16 1176 1177 1194 1195 +3179 17 1176 1177 1194 1198 +3180 18 1178 1177 1194 1195 +3181 19 1178 1177 1194 1198 +3182 84 1176 1181 1182 1183 +3183 84 1176 1181 1182 1184 +3184 83 1176 1181 1182 1187 +3185 55 1185 1181 1182 1183 +3186 55 1185 1181 1182 1184 +3187 13 1185 1181 1182 1187 +3188 55 1186 1181 1182 1183 +3189 55 1186 1181 1182 1184 +3190 13 1186 1181 1182 1187 +3191 55 1181 1182 1183 1188 +3192 55 1181 1182 1183 1189 +3193 55 1181 1182 1183 1190 +3194 55 1181 1182 1184 1191 +3195 55 1181 1182 1184 1192 +3196 55 1181 1182 1184 1193 +3197 55 1183 1182 1184 1191 +3198 55 1183 1182 1184 1192 +3199 55 1183 1182 1184 1193 +3200 55 1184 1182 1183 1188 +3201 55 1184 1182 1183 1189 +3202 55 1184 1182 1183 1190 +3203 13 1187 1182 1183 1188 +3204 13 1187 1182 1183 1189 +3205 13 1187 1182 1183 1190 +3206 13 1187 1182 1184 1191 +3207 13 1187 1182 1184 1192 +3208 13 1187 1182 1184 1193 +3209 26 1177 1194 1195 1196 +3210 27 1177 1194 1195 1199 +3211 28 1177 1194 1195 1200 +3212 29 1198 1194 1195 1196 +3213 30 1198 1194 1195 1199 +3214 31 1198 1194 1195 1200 +3215 32 1194 1195 1196 1197 +3216 33 1194 1195 1196 1218 +3217 34 1194 1195 1200 1201 +3218 35 1194 1195 1200 1207 +3219 35 1194 1195 1200 1208 +3220 8 1196 1195 1200 1201 +3221 9 1196 1195 1200 1207 +3222 9 1196 1195 1200 1208 +3223 10 1199 1195 1196 1197 +3224 11 1199 1195 1196 1218 +3225 12 1199 1195 1200 1201 +3226 13 1199 1195 1200 1207 +3227 13 1199 1195 1200 1208 +3228 14 1200 1195 1196 1197 +3229 15 1200 1195 1196 1218 +3230 85 1195 1196 1218 1219 +3231 17 1195 1196 1218 1222 +3232 86 1197 1196 1218 1219 +3233 19 1197 1196 1218 1222 +3234 67 1195 1200 1201 1202 +3235 21 1195 1200 1201 1209 +3236 21 1195 1200 1201 1210 +3237 68 1207 1200 1201 1202 +3238 23 1207 1200 1201 1209 +3239 23 1207 1200 1201 1210 +3240 68 1208 1200 1201 1202 +3241 23 1208 1200 1201 1209 +3242 23 1208 1200 1201 1210 +3243 153 1200 1201 1202 1203 +3244 68 1200 1201 1202 1211 +3245 68 1200 1201 1202 1212 +3246 154 1209 1201 1202 1203 +3247 23 1209 1201 1202 1211 +3248 23 1209 1201 1202 1212 +3249 154 1210 1201 1202 1203 +3250 23 1210 1201 1202 1211 +3251 23 1210 1201 1202 1212 +3252 155 1201 1202 1203 1204 +3253 156 1201 1202 1203 1213 +3254 157 1211 1202 1203 1204 +3255 158 1211 1202 1203 1213 +3256 157 1212 1202 1203 1204 +3257 158 1212 1202 1203 1213 +3258 159 1202 1203 1204 1205 +3259 159 1202 1203 1204 1206 +3260 160 1213 1203 1204 1205 +3261 160 1213 1203 1204 1206 +3262 160 1203 1204 1205 1214 +3263 160 1203 1204 1205 1215 +3264 160 1203 1204 1206 1216 +3265 160 1203 1204 1206 1217 +3266 160 1205 1204 1206 1216 +3267 160 1205 1204 1206 1217 +3268 160 1206 1204 1205 1214 +3269 160 1206 1204 1205 1215 +3270 87 1196 1218 1219 1220 +3271 88 1196 1218 1219 1223 +3272 88 1196 1218 1219 1224 +3273 89 1222 1218 1219 1220 +3274 90 1222 1218 1219 1223 +3275 90 1222 1218 1219 1224 +3276 91 1218 1219 1220 1221 +3277 92 1218 1219 1220 1225 +3278 93 1223 1219 1220 1221 +3279 94 1223 1219 1220 1225 +3280 93 1224 1219 1220 1221 +3281 94 1224 1219 1220 1225 +3282 185 1219 1220 1225 1226 +3283 96 1219 1220 1225 1229 +3284 86 1221 1220 1225 1226 +3285 19 1221 1220 1225 1229 +3286 186 1220 1225 1226 1227 +3287 88 1220 1225 1226 1230 +3288 88 1220 1225 1226 1231 +3289 187 1229 1225 1226 1227 +3290 90 1229 1225 1226 1230 +3291 90 1229 1225 1226 1231 +3292 188 1225 1226 1227 1228 +3293 188 1225 1226 1227 1232 +3294 189 1230 1226 1227 1228 +3295 189 1230 1226 1227 1232 +3296 189 1231 1226 1227 1228 +3297 189 1231 1226 1227 1232 + +Impropers + +1 1 2 3 4 20 +2 2 4 3 2 20 +3 3 20 3 2 4 +4 4 3 20 21 24 +5 5 21 20 3 24 +6 6 24 20 3 21 +7 1 21 22 23 37 +8 2 23 22 21 37 +9 3 37 22 21 23 +10 7 27 28 29 30 +11 2 29 28 27 30 +12 3 30 28 27 29 +13 4 28 30 35 36 +14 6 35 30 28 36 +15 6 36 30 28 35 +16 4 22 37 38 41 +17 5 38 37 22 41 +18 6 41 37 22 38 +19 1 38 39 40 56 +20 2 40 39 38 56 +21 3 56 39 38 40 +22 4 39 56 57 60 +23 5 57 56 39 60 +24 6 60 56 39 57 +25 1 57 58 59 76 +26 2 59 58 57 76 +27 3 76 58 57 59 +28 8 62 63 64 65 +29 9 64 63 62 65 +30 9 65 63 62 64 +31 9 63 64 66 71 +32 9 66 64 63 71 +33 10 71 64 63 66 +34 9 63 65 67 72 +35 9 67 65 63 72 +36 10 72 65 63 67 +37 9 64 66 68 73 +38 9 68 66 64 73 +39 10 73 66 64 68 +40 9 65 67 68 74 +41 9 68 67 65 74 +42 10 74 67 65 68 +43 9 66 68 67 75 +44 9 67 68 66 75 +45 10 75 68 66 67 +46 4 58 76 77 80 +47 5 77 76 58 80 +48 6 80 76 58 77 +49 1 77 78 79 92 +50 2 79 78 77 92 +51 3 92 78 77 79 +52 4 78 92 93 96 +53 5 93 92 78 96 +54 6 96 92 78 93 +55 1 93 94 95 114 +56 2 95 94 93 114 +57 3 114 94 93 95 +58 4 94 114 115 118 +59 5 115 114 94 118 +60 6 118 114 94 115 +61 1 115 116 117 128 +62 2 117 116 115 128 +63 3 128 116 115 117 +64 4 116 128 129 132 +65 5 129 128 116 132 +66 6 132 128 116 129 +67 1 129 130 131 147 +68 2 131 130 129 147 +69 3 147 130 129 131 +70 4 130 147 148 151 +71 5 148 147 130 151 +72 6 151 147 130 148 +73 1 148 149 150 161 +74 2 150 149 148 161 +75 3 161 149 148 150 +76 4 149 161 162 165 +77 11 162 161 149 165 +78 6 165 161 149 162 +79 12 162 163 164 168 +80 2 164 163 162 168 +81 3 168 163 162 164 +82 4 163 168 169 172 +83 5 169 168 163 172 +84 6 172 168 163 169 +85 1 169 170 171 190 +86 2 171 170 169 190 +87 3 190 170 169 171 +88 4 170 190 191 194 +89 5 191 190 170 194 +90 6 194 190 170 191 +91 1 191 192 193 204 +92 2 193 192 191 204 +93 3 204 192 191 193 +94 4 192 204 205 208 +95 5 205 204 192 208 +96 6 208 204 192 205 +97 1 205 206 207 223 +98 2 207 206 205 223 +99 3 223 206 205 207 +100 4 206 223 224 227 +101 5 224 223 206 227 +102 6 227 223 206 224 +103 1 224 225 226 237 +104 2 226 225 224 237 +105 3 237 225 224 226 +106 4 225 237 238 241 +107 5 238 237 225 241 +108 6 241 237 225 238 +109 1 238 239 240 256 +110 2 240 239 238 256 +111 3 256 239 238 240 +112 4 239 256 257 260 +113 5 257 256 239 260 +114 6 260 256 239 257 +115 1 257 258 259 271 +116 2 259 258 257 271 +117 3 271 258 257 259 +118 13 263 264 265 266 +119 14 265 264 263 266 +120 14 266 264 263 265 +121 4 258 271 272 275 +122 5 272 271 258 275 +123 6 275 271 258 272 +124 1 272 273 274 287 +125 2 274 273 272 287 +126 3 287 273 272 274 +127 4 273 287 288 291 +128 5 288 287 273 291 +129 6 291 287 273 288 +130 1 288 289 290 302 +131 2 290 289 288 302 +132 15 302 289 288 290 +133 13 294 295 296 297 +134 14 296 295 294 297 +135 14 297 295 294 296 +136 16 289 302 303 309 +137 17 303 302 289 309 +138 18 309 302 289 303 +139 1 303 304 305 316 +140 2 305 304 303 316 +141 3 316 304 303 305 +142 4 304 316 317 320 +143 5 317 316 304 320 +144 6 320 316 304 317 +145 1 317 318 319 327 +146 2 319 318 317 327 +147 3 327 318 317 319 +148 4 318 327 328 331 +149 5 328 327 318 331 +150 6 331 327 318 328 +151 1 328 329 330 339 +152 2 330 329 328 339 +153 3 339 329 328 330 +154 13 333 334 335 336 +155 14 335 334 333 336 +156 14 336 334 333 335 +157 4 329 339 340 343 +158 5 340 339 329 343 +159 6 343 339 329 340 +160 1 340 341 342 353 +161 2 342 341 340 353 +162 3 353 341 340 342 +163 4 341 353 354 357 +164 5 354 353 341 357 +165 6 357 353 341 354 +166 1 354 355 356 372 +167 2 356 355 354 372 +168 3 372 355 354 356 +169 4 355 372 373 376 +170 5 373 372 355 376 +171 6 376 372 355 373 +172 1 373 374 375 387 +173 2 375 374 373 387 +174 3 387 374 373 375 +175 13 379 380 381 382 +176 14 381 380 379 382 +177 14 382 380 379 381 +178 4 374 387 388 391 +179 5 388 387 374 391 +180 6 391 387 374 388 +181 1 388 389 390 401 +182 2 390 389 388 401 +183 3 401 389 388 390 +184 7 393 394 395 396 +185 2 395 394 393 396 +186 3 396 394 393 395 +187 4 394 396 399 400 +188 6 399 396 394 400 +189 6 400 396 394 399 +190 4 389 401 402 405 +191 5 402 401 389 405 +192 6 405 401 389 402 +193 1 402 403 404 417 +194 2 404 403 402 417 +195 3 417 403 402 404 +196 4 403 417 418 421 +197 5 418 417 403 421 +198 6 421 417 403 418 +199 1 418 419 420 439 +200 2 420 419 418 439 +201 3 439 419 418 420 +202 4 419 439 440 443 +203 5 440 439 419 443 +204 6 443 439 419 440 +205 1 440 441 442 449 +206 2 442 441 440 449 +207 3 449 441 440 442 +208 4 441 449 450 453 +209 5 450 449 441 453 +210 6 453 449 441 450 +211 1 450 451 452 471 +212 2 452 451 450 471 +213 3 471 451 450 452 +214 4 451 471 472 475 +215 5 472 471 451 475 +216 6 475 471 451 472 +217 1 472 473 474 490 +218 2 474 473 472 490 +219 3 490 473 472 474 +220 4 473 490 491 494 +221 5 491 490 473 494 +222 6 494 490 473 491 +223 1 491 492 493 507 +224 2 493 492 491 507 +225 3 507 492 491 493 +226 7 497 498 499 500 +227 2 499 498 497 500 +228 3 500 498 497 499 +229 4 498 500 505 506 +230 6 505 500 498 506 +231 6 506 500 498 505 +232 4 492 507 508 511 +233 5 508 507 492 511 +234 6 511 507 492 508 +235 1 508 509 510 519 +236 2 510 509 508 519 +237 3 519 509 508 510 +238 13 513 514 515 516 +239 14 515 514 513 516 +240 14 516 514 513 515 +241 4 509 519 520 523 +242 5 520 519 509 523 +243 6 523 519 509 520 +244 1 520 521 522 541 +245 2 522 521 520 541 +246 3 541 521 520 522 +247 4 521 541 542 545 +248 5 542 541 521 545 +249 6 545 541 521 542 +250 1 542 543 544 556 +251 2 544 543 542 556 +252 3 556 543 542 544 +253 13 548 549 550 551 +254 14 550 549 548 551 +255 14 551 549 548 550 +256 4 543 556 557 560 +257 11 557 556 543 560 +258 6 560 556 543 557 +259 12 557 558 559 563 +260 2 559 558 557 563 +261 3 563 558 557 559 +262 4 558 563 564 567 +263 5 564 563 558 567 +264 6 567 563 558 564 +265 1 564 565 566 582 +266 2 566 565 564 582 +267 15 582 565 564 566 +268 16 565 582 583 589 +269 17 583 582 565 589 +270 18 589 582 565 583 +271 1 583 584 585 596 +272 2 585 584 583 596 +273 15 596 584 583 585 +274 16 584 596 597 603 +275 17 597 596 584 603 +276 18 603 596 584 597 +277 1 597 598 599 610 +278 2 599 598 597 610 +279 3 610 598 597 599 +280 4 598 610 611 614 +281 5 611 610 598 614 +282 6 614 610 598 611 +283 1 611 612 613 622 +284 2 613 612 611 622 +285 3 622 612 611 613 +286 13 616 617 618 619 +287 14 618 617 616 619 +288 14 619 617 616 618 +289 4 612 622 623 626 +290 5 623 622 612 626 +291 6 626 622 612 623 +292 1 623 624 625 639 +293 2 625 624 623 639 +294 3 639 624 623 625 +295 7 629 630 631 632 +296 2 631 630 629 632 +297 3 632 630 629 631 +298 4 630 632 637 638 +299 6 637 632 630 638 +300 6 638 632 630 637 +301 4 624 639 640 643 +302 5 640 639 624 643 +303 6 643 639 624 640 +304 1 640 641 642 656 +305 2 642 641 640 656 +306 3 656 641 640 642 +307 7 646 647 648 649 +308 2 648 647 646 649 +309 3 649 647 646 648 +310 4 647 649 654 655 +311 6 654 649 647 655 +312 6 655 649 647 654 +313 4 641 656 657 660 +314 5 657 656 641 660 +315 6 660 656 641 657 +316 1 657 658 659 680 +317 2 659 658 657 680 +318 3 680 658 657 659 +319 19 664 665 666 675 +320 20 666 665 664 675 +321 21 675 665 664 666 +322 22 665 666 667 668 +323 22 667 666 665 668 +324 22 668 666 665 667 +325 20 666 667 676 677 +326 21 676 667 666 677 +327 21 677 667 666 676 +328 20 666 668 678 679 +329 21 678 668 666 679 +330 21 679 668 666 678 +331 4 658 680 681 684 +332 5 681 680 658 684 +333 6 684 680 658 681 +334 1 681 682 683 699 +335 2 683 682 681 699 +336 3 699 682 681 683 +337 4 682 699 700 703 +338 5 700 699 682 703 +339 6 703 699 682 700 +340 1 700 701 702 718 +341 2 702 701 700 718 +342 3 718 701 700 702 +343 4 701 718 719 722 +344 5 719 718 701 722 +345 6 722 718 701 719 +346 1 719 720 721 738 +347 2 721 720 719 738 +348 3 738 720 719 721 +349 8 724 725 726 727 +350 9 726 725 724 727 +351 9 727 725 724 726 +352 9 725 726 728 733 +353 9 728 726 725 733 +354 10 733 726 725 728 +355 9 725 727 729 734 +356 9 729 727 725 734 +357 10 734 727 725 729 +358 9 726 728 730 735 +359 9 730 728 726 735 +360 10 735 728 726 730 +361 9 727 729 730 736 +362 9 730 729 727 736 +363 10 736 729 727 730 +364 9 728 730 729 737 +365 9 729 730 728 737 +366 10 737 730 728 729 +367 4 720 738 739 742 +368 5 739 738 720 742 +369 6 742 738 720 739 +370 1 739 740 741 748 +371 2 741 740 739 748 +372 3 748 740 739 741 +373 4 740 748 749 752 +374 11 749 748 740 752 +375 6 752 748 740 749 +376 12 749 750 751 755 +377 2 751 750 749 755 +378 3 755 750 749 751 +379 4 750 755 756 759 +380 5 756 755 750 759 +381 6 759 755 750 756 +382 1 756 757 758 777 +383 2 758 757 756 777 +384 3 777 757 756 758 +385 4 757 777 778 781 +386 5 778 777 757 781 +387 6 781 777 757 778 +388 1 778 779 780 794 +389 2 780 779 778 794 +390 3 794 779 778 780 +391 7 784 785 786 787 +392 2 786 785 784 787 +393 3 787 785 784 786 +394 4 785 787 792 793 +395 6 792 787 785 793 +396 6 793 787 785 792 +397 4 779 794 795 798 +398 5 795 794 779 798 +399 6 798 794 779 795 +400 1 795 796 797 813 +401 2 797 796 795 813 +402 3 813 796 795 797 +403 4 796 813 814 817 +404 5 814 813 796 817 +405 6 817 813 796 814 +406 1 814 815 816 828 +407 2 816 815 814 828 +408 3 828 815 814 816 +409 13 820 821 822 823 +410 14 822 821 820 823 +411 14 823 821 820 822 +412 4 815 828 829 832 +413 5 829 828 815 832 +414 6 832 828 815 829 +415 1 829 830 831 840 +416 2 831 830 829 840 +417 3 840 830 829 831 +418 13 834 835 836 837 +419 14 836 835 834 837 +420 14 837 835 834 836 +421 4 830 840 841 844 +422 11 841 840 830 844 +423 6 844 840 830 841 +424 12 841 842 843 847 +425 2 843 842 841 847 +426 3 847 842 841 843 +427 4 842 847 848 851 +428 5 848 847 842 851 +429 6 851 847 842 848 +430 1 848 849 850 871 +431 2 850 849 848 871 +432 3 871 849 848 850 +433 19 855 856 857 866 +434 20 857 856 855 866 +435 21 866 856 855 857 +436 22 856 857 858 859 +437 22 858 857 856 859 +438 22 859 857 856 858 +439 20 857 858 867 868 +440 21 867 858 857 868 +441 21 868 858 857 867 +442 20 857 859 869 870 +443 21 869 859 857 870 +444 21 870 859 857 869 +445 4 849 871 872 875 +446 5 872 871 849 875 +447 6 875 871 849 872 +448 1 872 873 874 885 +449 2 874 873 872 885 +450 3 885 873 872 874 +451 4 873 885 886 889 +452 5 886 885 873 889 +453 6 889 885 873 886 +454 1 886 887 888 904 +455 2 888 887 886 904 +456 3 904 887 886 888 +457 4 887 904 905 908 +458 5 905 904 887 908 +459 6 908 904 887 905 +460 1 905 906 907 915 +461 2 907 906 905 915 +462 3 915 906 905 907 +463 4 906 915 916 919 +464 5 916 915 906 919 +465 6 919 915 906 916 +466 1 916 917 918 927 +467 2 918 917 916 927 +468 3 927 917 916 918 +469 13 921 922 923 924 +470 14 923 922 921 924 +471 14 924 922 921 923 +472 4 917 927 928 931 +473 5 928 927 917 931 +474 6 931 927 917 928 +475 1 928 929 930 948 +476 2 930 929 928 948 +477 3 948 929 928 930 +478 8 933 934 935 936 +479 9 935 934 933 936 +480 9 936 934 933 935 +481 9 934 935 937 943 +482 9 937 935 934 943 +483 10 943 935 934 937 +484 9 934 936 938 944 +485 9 938 936 934 944 +486 10 944 936 934 938 +487 9 935 937 939 945 +488 9 939 937 935 945 +489 10 945 937 935 939 +490 9 936 938 939 946 +491 9 939 938 936 946 +492 10 946 938 936 939 +493 9 937 939 938 940 +494 9 938 939 937 940 +495 23 940 939 937 938 +496 4 929 948 949 952 +497 5 949 948 929 952 +498 6 952 948 929 949 +499 1 949 950 951 962 +500 2 951 950 949 962 +501 3 962 950 949 951 +502 7 954 955 956 957 +503 2 956 955 954 957 +504 3 957 955 954 956 +505 4 955 957 960 961 +506 6 960 957 955 961 +507 6 961 957 955 960 +508 4 950 962 963 966 +509 5 963 962 950 966 +510 6 966 962 950 963 +511 1 963 964 965 981 +512 2 965 964 963 981 +513 3 981 964 963 965 +514 4 964 981 982 985 +515 5 982 981 964 985 +516 6 985 981 964 982 +517 1 982 983 984 998 +518 2 984 983 982 998 +519 3 998 983 982 984 +520 7 988 989 990 991 +521 2 990 989 988 991 +522 3 991 989 988 990 +523 4 989 991 996 997 +524 6 996 991 989 997 +525 6 997 991 989 996 +526 4 983 998 999 1002 +527 5 999 998 983 1002 +528 6 1002 998 983 999 +529 1 999 1000 1001 1020 +530 2 1001 1000 999 1020 +531 3 1020 1000 999 1001 +532 4 1000 1020 1021 1024 +533 5 1021 1020 1000 1024 +534 6 1024 1020 1000 1021 +535 1 1021 1022 1023 1035 +536 2 1023 1022 1021 1035 +537 3 1035 1022 1021 1023 +538 13 1027 1028 1029 1030 +539 14 1029 1028 1027 1030 +540 14 1030 1028 1027 1029 +541 4 1022 1035 1036 1039 +542 5 1036 1035 1022 1039 +543 6 1039 1035 1022 1036 +544 1 1036 1037 1038 1046 +545 2 1038 1037 1036 1046 +546 3 1046 1037 1036 1038 +547 4 1037 1046 1047 1050 +548 5 1047 1046 1037 1050 +549 6 1050 1046 1037 1047 +550 1 1047 1048 1049 1060 +551 2 1049 1048 1047 1060 +552 3 1060 1048 1047 1049 +553 4 1048 1060 1061 1064 +554 5 1061 1060 1048 1064 +555 6 1064 1060 1048 1061 +556 1 1061 1062 1063 1079 +557 2 1063 1062 1061 1079 +558 3 1079 1062 1061 1063 +559 4 1062 1079 1080 1083 +560 5 1080 1079 1062 1083 +561 6 1083 1079 1062 1080 +562 1 1080 1081 1082 1097 +563 2 1082 1081 1080 1097 +564 3 1097 1081 1080 1082 +565 24 1085 1086 1087 1088 +566 25 1087 1086 1085 1088 +567 26 1088 1086 1085 1087 +568 27 1086 1087 1089 1093 +569 28 1089 1087 1086 1093 +570 29 1093 1087 1086 1089 +571 26 1086 1088 1090 1094 +572 25 1090 1088 1086 1094 +573 30 1094 1088 1086 1090 +574 31 1087 1089 1090 1095 +575 31 1090 1089 1087 1095 +576 32 1095 1089 1087 1090 +577 27 1088 1090 1089 1096 +578 28 1089 1090 1088 1096 +579 29 1096 1090 1088 1089 +580 4 1081 1097 1098 1101 +581 5 1098 1097 1081 1101 +582 6 1101 1097 1081 1098 +583 1 1098 1099 1100 1116 +584 2 1100 1099 1098 1116 +585 3 1116 1099 1098 1100 +586 4 1099 1116 1117 1120 +587 5 1117 1116 1099 1120 +588 6 1120 1116 1099 1117 +589 1 1117 1118 1119 1132 +590 2 1119 1118 1117 1132 +591 3 1132 1118 1117 1119 +592 4 1118 1132 1133 1136 +593 5 1133 1132 1118 1136 +594 6 1136 1132 1118 1133 +595 1 1133 1134 1135 1151 +596 2 1135 1134 1133 1151 +597 3 1151 1134 1133 1135 +598 4 1134 1151 1152 1155 +599 5 1152 1151 1134 1155 +600 6 1155 1151 1134 1152 +601 1 1152 1153 1154 1175 +602 2 1154 1153 1152 1175 +603 3 1175 1153 1152 1154 +604 19 1159 1160 1161 1170 +605 20 1161 1160 1159 1170 +606 21 1170 1160 1159 1161 +607 22 1160 1161 1162 1163 +608 22 1162 1161 1160 1163 +609 22 1163 1161 1160 1162 +610 20 1161 1162 1171 1172 +611 21 1171 1162 1161 1172 +612 21 1172 1162 1161 1171 +613 20 1161 1163 1173 1174 +614 21 1173 1163 1161 1174 +615 21 1174 1163 1161 1173 +616 4 1153 1175 1176 1179 +617 5 1176 1175 1153 1179 +618 6 1179 1175 1153 1176 +619 1 1176 1177 1178 1194 +620 2 1178 1177 1176 1194 +621 3 1194 1177 1176 1178 +622 4 1177 1194 1195 1198 +623 5 1195 1194 1177 1198 +624 6 1198 1194 1177 1195 +625 1 1195 1196 1197 1218 +626 2 1197 1196 1195 1218 +627 3 1218 1196 1195 1197 +628 19 1202 1203 1204 1213 +629 20 1204 1203 1202 1213 +630 21 1213 1203 1202 1204 +631 22 1203 1204 1205 1206 +632 22 1205 1204 1203 1206 +633 22 1206 1204 1203 1205 +634 20 1204 1205 1214 1215 +635 21 1214 1205 1204 1215 +636 21 1215 1205 1204 1214 +637 20 1204 1206 1216 1217 +638 21 1216 1206 1204 1217 +639 21 1217 1206 1204 1216 +640 4 1196 1218 1219 1222 +641 11 1219 1218 1196 1222 +642 6 1222 1218 1196 1219 +643 12 1219 1220 1221 1225 +644 2 1221 1220 1219 1225 +645 3 1225 1220 1219 1221 +646 4 1220 1225 1226 1229 +647 11 1226 1225 1220 1229 +648 6 1229 1225 1220 1226 +649 33 1226 1227 1228 1232 +650 14 1228 1227 1226 1232 +651 14 1232 1227 1226 1228 + +Bond Coeffs + +1 1.448 381.3 -972.315 1446.3185625 +2 1.015 461.9 -1177.845 1752.0444375 +3 1.509 345.0 -879.75 1308.628125 +4 1.112 341.0 -869.55 1293.455625 +5 1.525 323.0 -823.65 1225.179375 +6 1.2255 662.0 -1688.1 2511.04875 +7 1.345 482.0 -1229.1 1828.28625 +8 1.525 323.0 -823.65 1225.179375 +9 1.112 341.0 -869.55 1293.455625 +10 1.805 215.8 -550.29 818.556375 +11 1.437 375.0 -956.25 1422.421875 +12 1.028 487.0 -1241.85 1847.251875 +13 1.509 345.0 -879.75 1308.628125 +14 1.525 323.0 -823.65 1225.179375 +15 1.499 453.2 -1155.66 1719.04425 +16 1.3887 471.9 -1203.345 1789.9756875 +17 1.1 370.5 -944.775 1405.3528125 +18 1.448 381.3 -972.315 1446.3185625 +19 1.015 461.9 -1177.845 1752.0444375 +20 1.413 410.0 -1045.5 1555.18125 +21 0.947 548.9 -1399.695 2082.0463125 +22 1.437 375.0 -956.25 1422.421875 +23 1.509 345.0 -879.75 1308.628125 +24 1.112 341.0 -869.55 1293.455625 +25 1.509 345.0 -879.75 1308.628125 +26 1.2553 705.0 -1797.75 2674.153125 +27 1.345 482.0 -1229.1 1828.28625 +28 1.437 375.0 -956.25 1422.421875 +29 1.437 375.0 -956.25 1422.421875 +30 1.525 323.0 -823.65 1225.179375 +31 1.5247 323.0 -823.65 1225.179375 +32 1.112 341.0 -869.55 1293.455625 +33 1.112 341.0 -869.55 1293.455625 +34 1.413 410.0 -1045.5 1555.18125 +35 1.446 374.8 -955.74 1421.66325 +36 1.325 491.4 -1253.07 1863.941625 +37 1.028 487.0 -1241.85 1847.251875 +38 1.355 431.6 -1100.58 1637.11275 +39 0.947 548.9 -1399.695 2082.0463125 +40 1.493 453.2 -1155.66 1719.04425 +41 1.373 653.9 -1667.445 2480.3244375 +42 1.371 539.6 -1375.98 2046.77025 +43 1.352 653.9 -1667.445 2480.3244375 +44 1.03 467.6 -1192.38 1773.66525 +45 1.081 370.5 -944.775 1405.3528125 +46 1.081 370.5 -944.775 1405.3528125 +47 1.509 345.0 -879.75 1308.628125 +48 0.9572 556.85 -1419.9675 2112.20165625 +49 -7.6 1.5537 0.0 0.0 + +Angle Coeffs + +1 0 108.5 43.2 -34.6524874495 7.94176512195 -5.68787029215 10.2422873821 +2 0 105.4 43.2 -34.6524874495 7.94176512195 -5.68787029215 10.2422873821 +3 0 110.7 75.2 -60.3209966714 13.8245541012 -9.90110754559 17.8291669244 +4 0 109.3 59.0 -47.3263138778 10.8463921804 -7.76815618604 13.9883091561 +5 0 110.7 75.2 -60.3209966714 13.8245541012 -9.90110754559 17.8291669244 +6 0 109.5 39.0 -31.2834956141 7.16964906843 -5.13488290263 9.24650944218 +7 0 110.6 58.0 -46.5241729646 10.6625550248 -7.63649252187 13.7512191704 +8 0 112.8 42.0 -33.6899183537 7.72116053523 -5.52987389514 9.95777939927 +9 1 122.4 80.0 -64.1712730547 14.7069724481 -10.5330931336 18.9671988558 +10 1 113.4 70.0 -56.1498639228 12.868600892 -9.21645649191 16.5962989988 +11 1 124.2 77.0 -61.7648503151 14.1554609813 -10.1381021411 18.2559288987 +12 0 111.0 48.2 -38.6631920154 8.86095089995 -6.346188613 11.4277373106 +13 0 110.7 42.0 -33.6899183537 7.72116053523 -5.52987389514 9.95777939927 +14 0 110.7 42.0 -33.6899183537 7.72116053523 -5.52987389514 9.95777939927 +15 0 107.8 40.0 -32.0856365273 7.35348622403 -5.2665465668 9.48359942788 +16 0 110.1 53.2 -42.6738965813 9.78013667795 -7.00450693385 12.6131872391 +17 0 110.8 53.2 -42.6738965813 9.78013667795 -7.00450693385 12.6131872391 +18 0 95.9 60.4 -48.4493111563 11.1037641983 -7.95248531587 14.3202351361 +19 0 108.0 53.2 -42.6738965813 9.78013667795 -7.00450693385 12.6131872391 +20 1 122.0 50.0 -40.1070456592 9.19185778003 -6.5831832085 11.8544992848 +21 1 121.0 36.0 -28.8770728746 6.61813760162 -4.73989191012 8.53523948509 +22 1 117.0 32.0 -25.6685092219 5.88278897922 -4.21323725344 7.5868795423 +23 0 109.6 61.0 -48.9305957042 11.2140664916 -8.03148351438 14.4624891275 +24 0 111.0 55.0 -44.1177502251 10.111043558 -7.24150152936 13.0399492133 +25 0 111.3 54.0 -43.3156093119 9.92720640244 -7.10983786519 12.8028592276 +26 0 110.6 47.6 -38.1819074675 8.75064860659 -6.2671904145 11.2854833192 +27 0 109.5 39.0 -31.2834956141 7.16964906843 -5.13488290263 9.24650944218 +28 1 122.4 80.0 -64.1712730547 14.7069724481 -10.5330931336 18.9671988558 +29 1 113.4 70.0 -56.1498639228 12.868600892 -9.21645649191 16.5962989988 +30 1 123.0 29.5 -23.6631569389 5.42319609022 -3.88407809302 6.99415457806 +31 0 111.3 54.0 -43.3156093119 9.92720640244 -7.10983786519 12.8028592276 +32 0 110.6 58.0 -46.5241729646 10.6625550248 -7.63649252187 13.7512191704 +33 0 110.7 42.0 -33.6899183537 7.72116053523 -5.52987389514 9.95777939927 +34 0 110.2 48.2 -38.6631920154 8.86095089995 -6.346188613 11.4277373106 +35 0 110.2 48.2 -38.6631920154 8.86095089995 -6.346188613 11.4277373106 +36 0 110.6 38.9 -31.2032815228 7.15126535287 -5.12171653622 9.22280044361 +37 0 109.3 39.6 -31.7647801621 7.27995136179 -5.21388110114 9.3887634336 +38 1 122.3 33.8 -27.1123628656 6.2136958593 -4.45023184895 8.01364151656 +39 1 121.7 54.7 -43.8771079511 10.0558924114 -7.2020024301 12.9688222176 +40 1 120.0 35.3 -28.3155742354 6.4894515927 -4.6477273452 8.3692764951 +41 0 111.0 48.2 -38.6631920154 8.86095089995 -6.346188613 11.4277373106 +42 0 109.5 56.1 -45.0001052296 10.3132644292 -7.38633155994 13.3007481976 +43 0 109.3 59.0 -47.3263138778 10.8463921804 -7.76815618604 13.9883091561 +44 0 110.9 43.2 -34.6524874495 7.94176512195 -5.68787029215 10.2422873821 +45 0 107.0 43.5 -34.8931297235 7.99691626863 -5.7273693914 10.3134143778 +46 0 107.5 59.7 -47.887812517 10.9750781894 -7.86032075095 14.1542721461 +47 0 107.5 59.7 -47.887812517 10.9750781894 -7.86032075095 14.1542721461 +48 0 110.0 59.0 -47.3263138778 10.8463921804 -7.76815618604 13.9883091561 +49 0 106.8 54.0 -43.3156093119 9.92720640244 -7.10983786519 12.8028592276 +50 0 111.0 48.2 -38.6631920154 8.86095089995 -6.346188613 11.4277373106 +51 1 122.0 50.0 -40.1070456592 9.19185778003 -6.5831832085 11.8544992848 +52 1 117.0 32.0 -25.6685092219 5.88278897922 -4.21323725344 7.5868795423 +53 0 109.8 55.0 -44.1177502251 10.111043558 -7.24150152936 13.0399492133 +54 0 111.0 55.0 -44.1177502251 10.111043558 -7.24150152936 13.0399492133 +55 0 109.5 39.0 -31.2834956141 7.16964906843 -5.13488290263 9.24650944218 +56 0 107.6 40.0 -32.0856365273 7.35348622403 -5.2665465668 9.48359942788 +57 1 122.4 80.0 -64.1712730547 14.7069724481 -10.5330931336 18.9671988558 +58 1 113.4 70.0 -56.1498639228 12.868600892 -9.21645649191 16.5962989988 +59 0 110.6 47.6 -38.1819074675 8.75064860659 -6.2671904145 11.2854833192 +60 0 109.5 39.0 -31.2834956141 7.16964906843 -5.13488290263 9.24650944218 +61 1 122.4 80.0 -64.1712730547 14.7069724481 -10.5330931336 18.9671988558 +62 1 134.0 57.6 -46.2033165993 10.5890201626 -7.5838270562 13.6563831761 +63 1 113.4 70.0 -56.1498639228 12.868600892 -9.21645649191 16.5962989988 +64 1 124.2 77.0 -61.7648503151 14.1554609813 -10.1381021411 18.2559288987 +65 1 122.0 50.0 -40.1070456592 9.19185778003 -6.5831832085 11.8544992848 +66 1 122.0 50.0 -40.1070456592 9.19185778003 -6.5831832085 11.8544992848 +67 1 112.5 54.7 -43.8771079511 10.0558924114 -7.2020024301 12.9688222176 +68 0 109.6 61.0 -48.9305957042 11.2140664916 -8.03148351438 14.4624891275 +69 0 111.0 55.0 -44.1177502251 10.111043558 -7.24150152936 13.0399492133 +70 0 104.0 54.0 -43.3156093119 9.92720640244 -7.10983786519 12.8028592276 +71 0 110.6 58.0 -46.5241729646 10.6625550248 -7.63649252187 13.7512191704 +72 0 112.8 42.0 -33.6899183537 7.72116053523 -5.52987389514 9.95777939927 +73 0 104.0 48.2 -38.6631920154 8.86095089995 -6.346188613 11.4277373106 +74 0 110.7 42.0 -33.6899183537 7.72116053523 -5.52987389514 9.95777939927 +75 0 110.7 42.0 -33.6899183537 7.72116053523 -5.52987389514 9.95777939927 +76 0 107.8 40.0 -32.0856365273 7.35348622403 -5.2665465668 9.48359942788 +77 0 104.0 48.2 -38.6631920154 8.86095089995 -6.346188613 11.4277373106 +78 0 104.0 54.0 -43.3156093119 9.92720640244 -7.10983786519 12.8028592276 +79 0 111.0 55.0 -44.1177502251 10.111043558 -7.24150152936 13.0399492133 +80 0 110.7 42.0 -33.6899183537 7.72116053523 -5.52987389514 9.95777939927 +81 0 107.8 40.0 -32.0856365273 7.35348622403 -5.2665465668 9.48359942788 +82 0 107.5 59.7 -47.887812517 10.9750781894 -7.86032075095 14.1542721461 +83 0 108.9 59.0 -47.3263138778 10.8463921804 -7.76815618604 13.9883091561 +84 0 106.8 54.0 -43.3156093119 9.92720640244 -7.10983786519 12.8028592276 +85 0 110.6 47.6 -38.1819074675 8.75064860659 -6.2671904145 11.2854833192 +86 0 110.6 47.6 -38.1819074675 8.75064860659 -6.2671904145 11.2854833192 +87 0 109.5 56.1 -45.0001052296 10.3132644292 -7.38633155994 13.3007481976 +88 0 111.0 54.6 -43.7968938598 10.0375086958 -7.18883606369 12.9451132191 +89 1 120.4 52.5 -42.1123979421 9.65145066903 -6.91234236893 12.4472242491 +90 1 122.4 13.7 -10.9893305106 2.51856903173 -1.80379219913 3.24813280405 +91 1 120.5 41.7 -33.4492760797 7.66600938855 -5.49037479589 9.88665240356 +92 1 120.0 28.8 -23.1016582997 5.2945100813 -3.7919135281 6.82819158807 +93 1 120.0 29.5 -23.6631569389 5.42319609022 -3.88407809302 6.99415457806 +94 1 120.0 43.2 -34.6524874495 7.94176512195 -5.68787029215 10.2422873821 +95 0 109.0 25.9 -20.7754496514 4.76138233006 -3.41008890201 6.14063062955 +96 0 112.7 38.8 -31.1230674315 7.13288163731 -5.1085501698 9.19909144504 +97 0 109.5 39.6 -31.7647801621 7.27995136179 -5.21388110114 9.3887634336 +98 1 122.0 36.0 -28.8770728746 6.61813760162 -4.73989191012 8.53523948509 +99 1 131.0 36.0 -28.8770728746 6.61813760162 -4.73989191012 8.53523948509 +100 1 104.7 47.5 -38.1016933762 8.73226489103 -6.25402404808 11.2617743206 +101 1 110.8 86.3 -69.2247608077 15.8651465283 -11.3625742179 20.4608657656 +102 1 125.5 35.3 -28.3155742354 6.4894515927 -4.6477273452 8.3692764951 +103 1 125.5 35.3 -28.3155742354 6.4894515927 -4.6477273452 8.3692764951 +104 1 128.0 35.3 -28.3155742354 6.4894515927 -4.6477273452 8.3692764951 +105 1 122.5 38.1 -30.5615687923 7.00419562839 -5.01638560488 9.03312845505 +106 1 110.3 28.8 -23.1016582997 5.2945100813 -3.7919135281 6.82819158807 +107 1 122.5 38.1 -30.5615687923 7.00419562839 -5.01638560488 9.03312845505 +108 0 109.6 61.0 -48.9305957042 11.2140664916 -8.03148351438 14.4624891275 +109 0 109.5 39.0 -31.2834956141 7.16964906843 -5.13488290263 9.24650944218 +110 1 122.4 80.0 -64.1712730547 14.7069724481 -10.5330931336 18.9671988558 +111 0 108.5 48.7 -39.064262472 8.95286947775 -6.41202044508 11.5462823034 + +Dihedral Coeffs + +1 3 0.6195 1 0.0 -0.2025 2 180.0 0.0175 3 0.0 +2 3 0.0 1 0.0 -0.0405 2 180.0 0.185 3 0.0 +3 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 +4 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 +5 3 -0.1985 1 0.0 1.098 2 180.0 -0.1855 3 0.0 +6 3 0.061 1 0.0 0.0455 2 180.0 0.012 3 0.0 +7 3 0.0 1 0.0 0.0 2 180.0 0.25 3 0.0 +8 3 1.2615 1 0.0 0.4655 2 180.0 -0.205 3 0.0 +9 3 0.0 1 0.0 0.0 2 180.0 0.09 3 0.0 +10 3 0.0 1 0.0 0.0 2 180.0 0.1175 3 0.0 +11 3 0.0 1 0.0 0.0 2 180.0 -0.005 3 0.0 +12 3 0.0 1 0.0 0.0 2 180.0 0.1705 3 0.0 +13 3 0.0 1 0.0 0.0 2 180.0 0.1495 3 0.0 +14 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 +15 3 0.2235 1 0.0 0.8535 2 180.0 -0.671 3 0.0 +16 3 -0.5 1 0.0 1.0 2 180.0 1.0 3 0.0 +17 3 0.0 1 0.0 0.5 2 180.0 0.4 3 0.0 +18 3 0.5 1 0.0 1.125 2 180.0 -1.125 3 0.0 +19 3 0.0 1 0.0 0.5 2 180.0 -0.275 3 0.0 +20 3 0.125 1 0.0 0.08 2 180.0 -0.9025 3 0.0 +21 3 0.0 1 0.0 0.0 2 180.0 0.1705 3 0.0 +22 3 0.0 1 0.0 0.0 2 180.0 0.2375 3 0.0 +23 3 0.0 1 0.0 0.0 2 180.0 0.1495 3 0.0 +24 3 -0.5305 1 0.0 0.066 2 180.0 0.165 3 0.0 +25 3 0.0 1 0.0 0.0 2 180.0 0.33 3 0.0 +26 3 0.397 1 0.0 -0.3195 2 180.0 0.36 3 0.0 +27 3 0.0 1 0.0 0.0 2 180.0 -0.063 3 0.0 +28 3 0.9995 1 0.0 0.0105 2 180.0 0.0 3 0.0 +29 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 +30 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 +31 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 +32 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 +33 3 -0.844 1 0.0 2.1245 2 180.0 0.0 3 0.0 +34 3 0.185 1 0.0 0.297 2 180.0 -0.113 3 0.0 +35 3 0.0 1 0.0 0.0 2 180.0 0.25 3 0.0 +36 3 -0.1285 1 0.0 -0.11 2 180.0 0.0 3 0.0 +37 3 0.0 1 0.0 0.0 2 180.0 0.09 3 0.0 +38 3 0.227 1 0.0 0.04 2 180.0 -0.155 3 0.0 +39 3 -0.2375 1 0.0 0.3875 2 180.0 0.021 3 0.0 +40 3 -0.077 1 0.0 0.022 2 180.0 -0.043 3 0.0 +41 3 0.0 1 0.0 0.0 2 180.0 0.115 3 0.0 +42 3 0.0 1 0.0 0.5 2 180.0 0.4 3 0.0 +43 3 0.9995 1 0.0 0.0105 2 180.0 0.0 3 0.0 +44 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 +45 3 0.387 1 0.0 -0.843 2 180.0 0.0 3 0.0 +46 3 0.0 1 0.0 0.0 2 180.0 0.25 3 0.0 +47 3 0.6715 1 0.0 0.0675 2 180.0 0.0 3 0.0 +48 3 0.0 1 0.0 0.0 2 180.0 0.09 3 0.0 +49 3 0.0 1 0.0 0.0 2 180.0 0.1705 3 0.0 +50 3 0.0 1 0.0 0.0 2 180.0 0.1495 3 0.0 +51 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 +52 3 0.2235 1 0.0 0.8535 2 180.0 -0.671 3 0.0 +53 3 0.428 1 0.0 0.4205 2 180.0 -0.187 3 0.0 +54 3 0.0 1 0.0 0.0 2 180.0 0.0455 3 0.0 +55 3 0.0 1 0.0 0.0 2 180.0 0.1705 3 0.0 +56 3 -0.3155 1 0.0 0.5335 2 180.0 -0.3515 3 0.0 +57 3 -1.142 1 0.0 0.67 2 180.0 0.0 3 0.0 +58 3 -1.6145 1 0.0 0.294 2 180.0 0.0 3 0.0 +59 3 0.0 1 0.0 0.0 2 180.0 0.25 3 0.0 +60 3 -0.2475 1 0.0 0.36 2 180.0 -0.242 3 0.0 +61 3 0.0 1 0.0 0.0 2 180.0 -0.045 3 0.0 +62 3 -0.305 1 0.0 2.106 2 180.0 0.0 3 0.0 +63 3 0.0 1 0.0 2.052 2 180.0 0.0 3 0.0 +64 3 -0.335 1 0.0 2.002 2 180.0 0.0 3 0.0 +65 3 0.275 1 0.0 2.267 2 180.0 -0.275 3 0.0 +66 3 0.0 1 0.0 2.036 2 180.0 0.0 3 0.0 +67 3 0.076 1 0.0 -0.1155 2 180.0 0.189 3 0.0 +68 3 0.0 1 0.0 0.0 2 180.0 0.1705 3 0.0 +69 3 0.076 1 0.0 -0.1155 2 180.0 0.189 3 0.0 +70 3 0.0 1 0.0 0.032 2 180.0 0.3025 3 0.0 +71 3 0.0 1 0.0 0.0 2 180.0 0.187 3 0.0 +72 3 0.0 1 0.0 0.0 2 180.0 -0.055 3 0.0 +73 3 0.0 1 0.0 -0.0405 2 180.0 0.185 3 0.0 +74 3 -0.547 1 0.0 0.3105 2 180.0 0.009 3 0.0 +75 3 -0.269 1 0.0 0.3515 2 180.0 -0.083 3 0.0 +76 3 0.0 1 0.0 0.0 2 180.0 0.1705 3 0.0 +77 3 -0.686 1 0.0 0.116 2 180.0 0.2 3 0.0 +78 3 0.0 1 0.0 0.0 2 180.0 0.1705 3 0.0 +79 3 -0.686 1 0.0 0.116 2 180.0 0.2 3 0.0 +80 3 0.0 1 0.0 0.0 2 180.0 0.133 3 0.0 +81 3 -0.4495 1 0.0 0.539 2 180.0 -0.1705 3 0.0 +82 3 0.574 1 0.0 -0.1445 2 180.0 -0.2785 3 0.0 +83 3 0.0 1 0.0 0.0 2 180.0 0.1705 3 0.0 +84 3 -0.3155 1 0.0 0.5335 2 180.0 -0.3515 3 0.0 +85 3 -0.5 1 0.0 1.0 2 180.0 1.0 3 0.0 +86 3 0.5 1 0.0 1.125 2 180.0 -1.125 3 0.0 +87 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 +88 3 0.0 1 0.0 0.0 2 180.0 -0.063 3 0.0 +89 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 +90 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 +91 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 +92 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 +93 3 0.0 1 0.0 0.0 2 180.0 0.1175 3 0.0 +94 3 0.0 1 0.0 0.0 2 180.0 -0.005 3 0.0 +95 3 -0.5 1 0.0 1.0 2 180.0 1.0 3 0.0 +96 3 0.0 1 0.0 0.5 2 180.0 0.4 3 0.0 +97 3 -2.1285 1 0.0 -0.11 2 180.0 0.0 3 0.0 +98 3 0.0 1 0.0 0.0 2 180.0 0.09 3 0.0 +99 3 0.0 1 0.0 0.05 2 180.0 0.0 3 0.0 +100 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 +101 3 -0.902 1 0.0 1.806 2 180.0 -0.098 3 0.0 +102 3 0.0 1 0.0 0.0 2 180.0 -0.005 3 0.0 +103 3 0.1775 1 0.0 0.739 2 180.0 -0.448 3 0.0 +104 3 -0.5 1 0.0 1.0 2 180.0 1.0 3 0.0 +105 3 -0.5 1 0.0 1.0 2 180.0 1.0 3 0.0 +106 3 0.5 1 0.0 1.125 2 180.0 -1.125 3 0.0 +107 3 0.5 1 0.0 1.125 2 180.0 -1.125 3 0.0 +108 3 -0.12 1 0.0 -1.543 2 180.0 -0.9145 3 0.0 +109 3 0.0 1 0.0 0.0 2 180.0 -0.063 3 0.0 +110 3 1.5445 1 0.0 2.688 2 180.0 -0.9145 3 0.0 +111 3 1.108 1 0.0 0.1075 2 180.0 0.405 3 0.0 +112 3 0.0 1 0.0 0.0 2 180.0 -0.063 3 0.0 +113 3 1.108 1 0.0 0.1075 2 180.0 0.405 3 0.0 +114 3 0.0 1 0.0 0.0 2 180.0 -0.063 3 0.0 +115 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 +116 3 0.0 1 0.0 0.0 2 180.0 -0.063 3 0.0 +117 3 1.108 1 0.0 0.1075 2 180.0 0.405 3 0.0 +118 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 +119 3 -1.059 1 0.0 0.5865 2 180.0 0.0 3 0.0 +120 3 -0.1005 1 0.0 0.3435 2 180.0 0.0 3 0.0 +121 3 0.0 1 0.0 0.0 2 180.0 0.25 3 0.0 +122 3 -0.464 1 0.0 0.5135 2 180.0 0.0 3 0.0 +123 3 0.0 1 0.0 0.0 2 180.0 0.09 3 0.0 +124 3 0.0 1 0.0 0.0 2 180.0 0.1705 3 0.0 +125 3 0.0 1 0.0 0.0 2 180.0 0.1495 3 0.0 +126 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 +127 3 1.1125 1 0.0 -0.626 2 180.0 -0.5335 3 0.0 +128 3 0.076 1 0.0 -0.1155 2 180.0 0.189 3 0.0 +129 3 0.0 1 0.0 0.0 2 180.0 0.1705 3 0.0 +130 3 0.0 1 0.0 0.0 2 180.0 0.1705 3 0.0 +131 3 0.0 1 0.0 0.0 2 180.0 0.1495 3 0.0 +132 3 -0.1005 1 0.0 0.3435 2 180.0 0.0 3 0.0 +133 3 0.0 1 0.0 0.0 2 180.0 0.1705 3 0.0 +134 3 0.0 1 0.0 0.0 2 180.0 0.25 3 0.0 +135 3 0.0 1 0.0 0.0 2 180.0 0.1495 3 0.0 +136 3 0.096 1 0.0 -0.0575 2 180.0 -0.1545 3 0.0 +137 3 -0.832 1 0.0 -0.2655 2 180.0 0.0 3 0.0 +138 3 0.0 1 0.0 0.0 2 180.0 0.1705 3 0.0 +139 3 0.635 1 0.0 -0.5115 2 180.0 -0.3635 3 0.0 +140 3 0.0 1 0.0 0.0 2 180.0 0.137 3 0.0 +141 3 0.0825 1 0.0 0.7 2 180.0 0.0 3 0.0 +142 3 -0.589 1 0.0 0.5275 2 180.0 0.0 3 0.0 +143 3 0.0 1 0.0 0.0 2 180.0 0.09 3 0.0 +144 3 0.0 1 0.0 0.5195 2 180.0 0.0 3 0.0 +145 3 -0.254 1 0.0 -0.1065 2 180.0 -0.1685 3 0.0 +146 3 -1.5315 1 0.0 -0.476 2 180.0 0.199 3 0.0 +147 3 0.0 1 0.0 0.0 2 180.0 0.09 3 0.0 +148 3 0.5455 1 0.0 0.224 2 180.0 0.298 3 0.0 +149 3 0.1405 1 0.0 0.332 2 180.0 -0.4235 3 0.0 +150 3 0.1775 1 0.0 0.739 2 180.0 -0.448 3 0.0 +151 3 -1.059 1 0.0 0.5865 2 180.0 0.0 3 0.0 +152 3 1.1125 1 0.0 -0.626 2 180.0 -0.5335 3 0.0 +153 3 -0.2675 1 0.0 -0.055 2 180.0 -0.0365 3 0.0 +154 3 0.0 1 0.0 0.0 2 180.0 0.187 3 0.0 +155 3 0.491 1 0.0 0.497 2 180.0 0.085 3 0.0 +156 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 +157 3 0.0 1 0.0 0.0 2 180.0 -0.063 3 0.0 +158 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 +159 3 0.0 1 0.0 2.25 2 180.0 0.0 3 0.0 +160 3 0.0 1 0.0 2.0 2 180.0 0.0 3 0.0 +161 3 0.0 1 0.0 2.235 2 180.0 0.0 3 0.0 +162 3 0.0 1 0.0 2.235 2 180.0 0.0 3 0.0 +163 3 0.0 1 0.0 1.0405 2 180.0 0.0 3 0.0 +164 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 +165 3 0.0695 1 0.0 -0.407 2 180.0 0.0 3 0.0 +166 3 0.0 1 0.0 0.0 2 180.0 0.25 3 0.0 +167 3 -0.9105 1 0.0 -1.2185 2 180.0 1.0295 3 0.0 +168 3 0.547 1 0.0 -0.08 2 180.0 0.2515 3 0.0 +169 3 0.0 1 0.0 0.0 2 180.0 0.1495 3 0.0 +170 3 0.0 1 0.0 0.0 2 180.0 0.1495 3 0.0 +171 3 0.0 1 0.0 2.106 2 180.0 0.0 3 0.0 +172 3 0.0 1 0.0 2.052 2 180.0 0.0 3 0.0 +173 3 0.0 1 0.0 2.106 2 180.0 0.0 3 0.0 +174 3 0.0 1 0.0 2.051 2 180.0 0.0 3 0.0 +175 3 0.45 1 0.0 4.0 2 180.0 0.0 3 0.0 +176 3 0.3775 1 0.0 1.5 2 180.0 0.0 3 0.0 +177 3 0.0 1 0.0 3.0 2 180.0 0.0 3 0.0 +178 3 -1.575 1 0.0 1.5 2 180.0 0.0 3 0.0 +179 3 0.0 1 0.0 4.0 2 180.0 0.0 3 0.0 +180 3 0.0 1 0.0 1.5 2 180.0 0.0 3 0.0 +181 3 -1.372 1 0.0 1.5 2 180.0 0.0 3 0.0 +182 3 -0.265 1 0.0 1.5 2 180.0 0.0 3 0.0 +183 3 0.0 1 0.0 1.5 2 180.0 0.0 3 0.0 +184 3 -0.265 1 0.0 1.5 2 180.0 0.0 3 0.0 +185 3 -0.5 1 0.0 1.0 2 180.0 1.0 3 0.0 +186 3 -0.428 1 0.0 0.024 2 180.0 -0.921 3 0.0 +187 3 0.0 1 0.0 4.0 2 180.0 0.0 3 0.0 +188 3 -0.0295 1 0.0 0.95 2 180.0 -0.0225 3 0.0 +189 3 -0.077 1 0.0 0.022 2 180.0 -0.043 3 0.0 + +Improper Coeffs + +1 49.6 +2 54.0 +3 107.9 +4 70.5 +5 41.7 +6 12.9 +7 20.9 +8 14.4 +9 14.4 +10 15.1 +11 41.7 +12 49.6 +13 121.6 +14 118.7 +15 49.6 +16 14.4 +17 14.4 +18 14.4 +19 0.7 +20 3.6 +21 12.9 +22 1.4 +23 14.4 +24 14.4 +25 14.4 +26 14.4 +27 15.1 +28 15.1 +29 12.9 +30 14.4 +31 14.4 +32 14.4 +33 121.6 + +BondAngle Coeffs + +1 4.3 4.3 1.448 1.015 +2 0.0 0.0 0.0 0.0 +3 18.7 18.7 1.509 1.448 +4 11.5 11.5 1.112 1.448 +5 18.7 18.7 1.525 1.448 +6 11.5 11.5 1.509 1.112 +7 18.7 18.7 1.509 1.525 +8 11.5 11.5 1.112 1.525 +9 18.7 18.7 1.2255 1.509 +10 18.7 18.7 1.345 1.509 +11 18.7 18.7 1.345 1.2255 +12 18.7 18.7 1.525 1.525 +13 11.5 11.5 1.525 1.112 +14 11.5 11.5 1.525 1.112 +15 0.0 0.0 0.0 0.0 +16 18.7 18.7 1.525 1.805 +17 11.5 11.5 1.112 1.805 +18 -5.75 -5.75 1.805 1.805 +19 11.5 11.5 1.112 1.805 +20 7.2 7.2 1.345 1.437 +21 4.3 4.3 1.345 1.028 +22 4.3 4.3 1.028 1.437 +23 18.7 18.7 1.437 1.509 +24 11.5 11.5 1.437 1.112 +25 18.7 18.7 1.437 1.525 +26 18.7 18.7 1.509 1.525 +27 11.5 11.5 1.509 1.112 +28 18.7 18.7 1.2255 1.509 +29 18.7 18.7 1.345 1.509 +30 0.0 0.0 0.0 0.0 +31 18.7 18.7 1.437 1.525 +32 18.7 18.7 1.509 1.525 +33 11.5 11.5 1.112 1.525 +34 18.7 18.7 1.525 1.525 +35 18.7 18.7 1.525 1.525 +36 18.7 18.7 1.525 1.499 +37 11.5 11.5 1.112 1.499 +38 18.7 18.7 1.499 1.3887 +39 18.7 18.7 1.3887 1.3887 +40 11.5 11.5 1.3887 1.1 +41 18.7 18.7 1.525 1.525 +42 18.7 18.7 1.525 1.448 +43 11.5 11.5 1.112 1.448 +44 4.3 4.3 1.448 1.015 +45 0.0 0.0 0.0 0.0 +46 18.7 18.7 1.525 1.413 +47 18.7 18.7 1.525 1.413 +48 11.5 11.5 1.112 1.413 +49 12.95 12.95 1.413 0.947 +50 18.7 18.7 1.525 1.525 +51 7.2 7.2 1.437 1.345 +52 4.3 4.3 1.437 1.028 +53 18.7 18.7 1.437 1.509 +54 11.5 11.5 1.437 1.112 +55 11.5 11.5 1.509 1.112 +56 0.0 0.0 0.0 0.0 +57 18.7 18.7 1.509 1.2255 +58 18.7 18.7 1.345 1.509 +59 18.7 18.7 1.525 1.509 +60 11.5 11.5 1.112 1.509 +61 18.7 18.7 1.509 1.2553 +62 18.7 18.7 1.2553 1.2553 +63 18.7 18.7 1.509 1.345 +64 18.7 18.7 1.2255 1.345 +65 7.2 7.2 1.345 1.437 +66 7.2 7.2 1.345 1.437 +67 7.2 7.2 1.437 1.437 +68 18.7 18.7 1.509 1.437 +69 11.5 11.5 1.112 1.437 +70 18.7 18.7 1.437 1.525 +71 18.7 18.7 1.509 1.525 +72 11.5 11.5 1.112 1.525 +73 18.7 18.7 1.525 1.5247 +74 11.5 11.5 1.525 1.112 +75 11.5 11.5 1.112 1.5247 +76 0.0 0.0 0.0 0.0 +77 18.7 18.7 1.5247 1.5247 +78 18.7 18.7 1.437 1.5247 +79 11.5 11.5 1.112 1.437 +80 11.5 11.5 1.112 1.5247 +81 0.0 0.0 0.0 0.0 +82 18.7 18.7 1.525 1.413 +83 11.5 11.5 1.112 1.413 +84 12.95 12.95 1.413 0.947 +85 18.7 18.7 1.525 1.509 +86 18.7 18.7 1.509 1.525 +87 18.7 18.7 1.446 1.525 +88 11.5 11.5 1.446 1.112 +89 7.2 7.2 1.446 1.325 +90 4.3 4.3 1.446 1.028 +91 4.3 4.3 1.028 1.325 +92 18.7 18.7 1.325 1.325 +93 0.0 0.0 0.0 0.0 +94 18.7 18.7 1.3887 1.355 +95 12.95 12.95 1.355 0.947 +96 18.7 18.7 1.525 1.493 +97 11.5 11.5 1.112 1.493 +98 18.7 18.7 1.493 1.373 +99 18.7 18.7 1.493 1.371 +100 18.7 18.7 1.373 1.371 +101 14.4 14.4 1.373 1.352 +102 4.3 4.3 1.03 1.373 +103 4.3 4.3 1.03 1.352 +104 11.5 11.5 1.371 1.081 +105 11.5 11.5 1.373 1.081 +106 18.7 18.7 1.352 1.352 +107 11.5 11.5 1.352 1.081 +108 18.7 18.7 1.437 1.509 +109 11.5 11.5 1.112 1.509 +110 18.7 18.7 1.509 1.2553 +111 0.0 0.0 0.0 0.0 diff --git a/src/AMOEBA/angle_amoeba.cpp b/src/AMOEBA/angle_amoeba.cpp index 8b529759fd..5936ff03b4 100644 --- a/src/AMOEBA/angle_amoeba.cpp +++ b/src/AMOEBA/angle_amoeba.cpp @@ -35,6 +35,8 @@ using namespace MathConst; AngleAmoeba::AngleAmoeba(LAMMPS *lmp) : Angle(lmp) { pflag = nullptr; + ubflag = nullptr; + theta0 = nullptr; k2 = nullptr; k3 = nullptr; @@ -46,6 +48,9 @@ AngleAmoeba::AngleAmoeba(LAMMPS *lmp) : Angle(lmp) ba_k2 = nullptr; ba_r1 = nullptr; ba_r2 = nullptr; + + ub_k = nullptr; + ub_r0 = nullptr; } /* ---------------------------------------------------------------------- */ @@ -58,8 +63,11 @@ AngleAmoeba::~AngleAmoeba() memory->destroy(setflag); memory->destroy(setflag_a); memory->destroy(setflag_ba); + memory->destroy(setflag_ub); memory->destroy(pflag); + memory->destroy(ubflag); + memory->destroy(theta0); memory->destroy(k2); memory->destroy(k3); @@ -71,6 +79,9 @@ AngleAmoeba::~AngleAmoeba() memory->destroy(ba_k2); memory->destroy(ba_r1); memory->destroy(ba_r2); + + memory->destroy(ub_k); + memory->destroy(ub_r0); } } @@ -78,7 +89,7 @@ AngleAmoeba::~AngleAmoeba() void AngleAmoeba::compute(int eflag, int vflag) { - int i1,i2,i3,n,type,tflag; + int i1,i2,i3,n,type,tflag,uflag; double delx1,dely1,delz1,delx2,dely2,delz2; double f1[3],f3[3]; double dtheta,dtheta2,dtheta3,dtheta4,dtheta5,dtheta6,de_angle; @@ -112,127 +123,17 @@ void AngleAmoeba::compute(int eflag, int vflag) if (ba_k1[type] != 0.0) tinker_bondangle(i1,i2,i3,type,eflag); + + // Urey-Bradley H-H bond term within water molecules + + uflag = ubflag[type]; + + if (uflag) tinker_urey_bradley(i1,i3,type,eflag); } } /* ---------------------------------------------------------------------- */ -void AngleAmoeba::tinker_bondangle(int i1, int i2, int i3, int type, int eflag) -{ - double delx1,dely1,delz1,delx2,dely2,delz2; - double rsq1,r1,rsq2,r2,c,s,dtheta; - double dr1,dr2,aa1,aa2,b1,b2; - double aa11,aa12,aa21,aa22; - double vx11,vx12,vy11,vy12,vz11,vz12,vx21,vx22,vy21,vy22,vz21,vz22; - double eangle,f1[3],f3[3]; - - double **x = atom->x; - double **f = atom->f; - int nlocal = atom->nlocal; - int newton_bond = force->newton_bond; - - // 1st bond - - delx1 = x[i1][0] - x[i2][0]; - dely1 = x[i1][1] - x[i2][1]; - delz1 = x[i1][2] - x[i2][2]; - - rsq1 = delx1*delx1 + dely1*dely1 + delz1*delz1; - r1 = sqrt(rsq1); - - // 2nd bond - - delx2 = x[i3][0] - x[i2][0]; - dely2 = x[i3][1] - x[i2][1]; - delz2 = x[i3][2] - x[i2][2]; - - rsq2 = delx2*delx2 + dely2*dely2 + delz2*delz2; - r2 = sqrt(rsq2); - - // angle (cos and sin) - - c = delx1*delx2 + dely1*dely2 + delz1*delz2; - c /= r1*r2; - - if (c > 1.0) c = 1.0; - if (c < -1.0) c = -1.0; - - s = sqrt(1.0 - c*c); - if (s < SMALL) s = SMALL; - s = 1.0/s; - - dtheta = acos(c) - theta0[type]; - - // force & energy for bond-angle term - - dr1 = r1 - ba_r1[type]; - dr2 = r2 - ba_r2[type]; - - aa1 = s * dr1 * ba_k1[type]; - aa2 = s * dr2 * ba_k2[type]; - - aa11 = aa1 * c / rsq1; - aa12 = -aa1 / (r1 * r2); - aa21 = aa2 * c / rsq1; - aa22 = -aa2 / (r1 * r2); - - vx11 = (aa11 * delx1) + (aa12 * delx2); - vx12 = (aa21 * delx1) + (aa22 * delx2); - vy11 = (aa11 * dely1) + (aa12 * dely2); - vy12 = (aa21 * dely1) + (aa22 * dely2); - vz11 = (aa11 * delz1) + (aa12 * delz2); - vz12 = (aa21 * delz1) + (aa22 * delz2); - - aa11 = aa1 * c / rsq2; - aa21 = aa2 * c / rsq2; - - vx21 = (aa11 * delx2) + (aa12 * delx1); - vx22 = (aa21 * delx2) + (aa22 * delx1); - vy21 = (aa11 * dely2) + (aa12 * dely1); - vy22 = (aa21 * dely2) + (aa22 * dely1); - vz21 = (aa11 * delz2) + (aa12 * delz1); - vz22 = (aa21 * delz2) + (aa22 * delz1); - - b1 = ba_k1[type] * dtheta / r1; - b2 = ba_k2[type] * dtheta / r2; - - f1[0] -= vx11 + b1*delx1 + vx12; - f1[1] -= vy11 + b1*dely1 + vy12; - f1[2] -= vz11 + b1*delz1 + vz12; - - f3[0] -= vx21 + b2*delx2 + vx22; - f3[1] -= vy21 + b2*dely2 + vy22; - f3[2] -= vz21 + b2*delz2 + vz22; - - eangle = 0.0; - if (eflag) eangle = ba_k1[type]*dr1*dtheta + ba_k2[type]*dr2*dtheta; - - // apply force to each of 3 atoms - - if (newton_bond || i1 < nlocal) { - f[i1][0] += f1[0]; - f[i1][1] += f1[1]; - f[i1][2] += f1[2]; - } - - if (newton_bond || i2 < nlocal) { - f[i2][0] -= f1[0] + f3[0]; - f[i2][1] -= f1[1] + f3[1]; - f[i2][2] -= f1[2] + f3[2]; - } - - if (newton_bond || i3 < nlocal) { - f[i3][0] += f3[0]; - f[i3][1] += f3[1]; - f[i3][2] += f3[2]; - } - - if (evflag) ev_tally(i1,i2,i3,nlocal,newton_bond,eangle,f1,f3, - delx1,dely1,delz1,delx2,dely2,delz2); -} - -/* ---------------------------------------------------------------------- */ - void AngleAmoeba::tinker_angle(int i1, int i2, int i3, int type, int eflag) { double delx1,dely1,delz1,delx2,dely2,delz2; @@ -516,12 +417,178 @@ void AngleAmoeba::tinker_anglep(int i1, int i2, int i3, int type, int eflag) /* ---------------------------------------------------------------------- */ +void AngleAmoeba::tinker_bondangle(int i1, int i2, int i3, int type, int eflag) +{ + double delx1,dely1,delz1,delx2,dely2,delz2; + double rsq1,r1,rsq2,r2,c,s,dtheta; + double dr1,dr2,aa1,aa2,b1,b2; + double aa11,aa12,aa21,aa22; + double vx11,vx12,vy11,vy12,vz11,vz12,vx21,vx22,vy21,vy22,vz21,vz22; + double eangle,f1[3],f3[3]; + + double **x = atom->x; + double **f = atom->f; + int nlocal = atom->nlocal; + int newton_bond = force->newton_bond; + + // 1st bond + + delx1 = x[i1][0] - x[i2][0]; + dely1 = x[i1][1] - x[i2][1]; + delz1 = x[i1][2] - x[i2][2]; + + rsq1 = delx1*delx1 + dely1*dely1 + delz1*delz1; + r1 = sqrt(rsq1); + + // 2nd bond + + delx2 = x[i3][0] - x[i2][0]; + dely2 = x[i3][1] - x[i2][1]; + delz2 = x[i3][2] - x[i2][2]; + + rsq2 = delx2*delx2 + dely2*dely2 + delz2*delz2; + r2 = sqrt(rsq2); + + // angle (cos and sin) + + c = delx1*delx2 + dely1*dely2 + delz1*delz2; + c /= r1*r2; + + if (c > 1.0) c = 1.0; + if (c < -1.0) c = -1.0; + + s = sqrt(1.0 - c*c); + if (s < SMALL) s = SMALL; + s = 1.0/s; + + dtheta = acos(c) - theta0[type]; + + // force & energy for bond-angle term + + dr1 = r1 - ba_r1[type]; + dr2 = r2 - ba_r2[type]; + + aa1 = s * dr1 * ba_k1[type]; + aa2 = s * dr2 * ba_k2[type]; + + aa11 = aa1 * c / rsq1; + aa12 = -aa1 / (r1 * r2); + aa21 = aa2 * c / rsq1; + aa22 = -aa2 / (r1 * r2); + + vx11 = (aa11 * delx1) + (aa12 * delx2); + vx12 = (aa21 * delx1) + (aa22 * delx2); + vy11 = (aa11 * dely1) + (aa12 * dely2); + vy12 = (aa21 * dely1) + (aa22 * dely2); + vz11 = (aa11 * delz1) + (aa12 * delz2); + vz12 = (aa21 * delz1) + (aa22 * delz2); + + aa11 = aa1 * c / rsq2; + aa21 = aa2 * c / rsq2; + + vx21 = (aa11 * delx2) + (aa12 * delx1); + vx22 = (aa21 * delx2) + (aa22 * delx1); + vy21 = (aa11 * dely2) + (aa12 * dely1); + vy22 = (aa21 * dely2) + (aa22 * dely1); + vz21 = (aa11 * delz2) + (aa12 * delz1); + vz22 = (aa21 * delz2) + (aa22 * delz1); + + b1 = ba_k1[type] * dtheta / r1; + b2 = ba_k2[type] * dtheta / r2; + + f1[0] -= vx11 + b1*delx1 + vx12; + f1[1] -= vy11 + b1*dely1 + vy12; + f1[2] -= vz11 + b1*delz1 + vz12; + + f3[0] -= vx21 + b2*delx2 + vx22; + f3[1] -= vy21 + b2*dely2 + vy22; + f3[2] -= vz21 + b2*delz2 + vz22; + + eangle = 0.0; + if (eflag) eangle = ba_k1[type]*dr1*dtheta + ba_k2[type]*dr2*dtheta; + + // apply force to each of 3 atoms + + if (newton_bond || i1 < nlocal) { + f[i1][0] += f1[0]; + f[i1][1] += f1[1]; + f[i1][2] += f1[2]; + } + + if (newton_bond || i2 < nlocal) { + f[i2][0] -= f1[0] + f3[0]; + f[i2][1] -= f1[1] + f3[1]; + f[i2][2] -= f1[2] + f3[2]; + } + + if (newton_bond || i3 < nlocal) { + f[i3][0] += f3[0]; + f[i3][1] += f3[1]; + f[i3][2] += f3[2]; + } + + if (evflag) ev_tally(i1,i2,i3,nlocal,newton_bond,eangle,f1,f3, + delx1,dely1,delz1,delx2,dely2,delz2); +} + +/* ---------------------------------------------------------------------- */ + +void AngleAmoeba::tinker_urey_bradley(int i1, int i2, int type, int eflag) +{ + double delx,dely,delz; + double rsq,r,dr,rk; + double fbond,ebond; + + double **x = atom->x; + double **f = atom->f; + int nlocal = atom->nlocal; + int newton_bond = force->newton_bond; + + delx = x[i1][0] - x[i2][0]; + dely = x[i1][1] - x[i2][1]; + delz = x[i1][2] - x[i2][2]; + + rsq = delx*delx + dely*dely + delz*delz; + r = sqrt(rsq); + dr = r - ub_r0[type]; + rk = ub_k[type] * dr; + + // force & energy + + if (r > 0.0) fbond = -2.0*rk/r; + else fbond = 0.0; + + if (eflag) ebond = rk*dr; + + // apply force to each of 2 atoms + + if (newton_bond || i1 < nlocal) { + f[i1][0] += delx*fbond; + f[i1][1] += dely*fbond; + f[i1][2] += delz*fbond; + } + + if (newton_bond || i2 < nlocal) { + f[i2][0] -= delx*fbond; + f[i2][1] -= dely*fbond; + f[i2][2] -= delz*fbond; + } + + // NOTE: there is no force on i2 for UB + + //if (evflag) ev_tally(i1,i2,i3,nlocal,newton_bond,ebond,f1,f3, + // delx1,dely1,delz1,delx2,dely2,delz2); +} + +/* ---------------------------------------------------------------------- */ + void AngleAmoeba::allocate() { allocated = 1; int n = atom->nangletypes; memory->create(pflag,n+1,"angle:pflag"); + memory->create(ubflag,n+1,"angle:ubflag"); memory->create(theta0,n+1,"angle:theta0"); memory->create(k2,n+1,"angle:k2"); memory->create(k3,n+1,"angle:k3"); @@ -534,11 +601,16 @@ void AngleAmoeba::allocate() memory->create(ba_r1,n+1,"angle:ba_r1"); memory->create(ba_r2,n+1,"angle:ba_r2"); - memory->create(setflag,n+1,"angle:setflag"); - memory->create(setflag_a,n+1,"angle:setflag"); - memory->create(setflag_ba,n+1,"angle:setflag"); + memory->create(ub_k,n+1,"angle:ub_k"); + memory->create(ub_r0,n+1,"angle:ub_r0"); - for (int i = 1; i <= n; i++) setflag[i] = setflag_a[i] = setflag_ba[i] = 0; + memory->create(setflag,n+1,"angle:setflag"); + memory->create(setflag_a,n+1,"angle:setflag_a"); + memory->create(setflag_ba,n+1,"angle:setflag_ba"); + memory->create(setflag_ub,n+1,"angle:setflag_ub"); + + for (int i = 1; i <= n; i++) + setflag[i] = setflag_a[i] = setflag_ba[i] = setflag_ub[i] = 0; } /* ---------------------------------------------------------------------- @@ -572,6 +644,19 @@ void AngleAmoeba::coeff(int narg, char **arg) count++; } + } else if (strcmp(arg[1],"ub") == 0) { + if (narg != 4) error->all(FLERR,"Incorrect args for angle coefficients"); + + double ub_k_one = utils::numeric(FLERR,arg[2],false,lmp); + double ub_r0_one = utils::numeric(FLERR,arg[3],false,lmp); + + for (int i = ilo; i <= ihi; i++) { + ub_k[i] = ub_k_one; + ub_r0[i] = ub_r0_one; + setflag_ub[i] = 1; + count++; + } + } else { if (narg != 8) error->all(FLERR,"Incorrect args for angle coefficients"); @@ -601,7 +686,8 @@ void AngleAmoeba::coeff(int narg, char **arg) if (count == 0) error->all(FLERR,"Incorrect args for angle coefficients"); for (int i = ilo; i <= ihi; i++) - if (setflag_a[i] == 1 && setflag_ba[i] == 1) setflag[i] = 1; + if (setflag_a[i] == 1 && setflag_ba[i] == 1 && setflag_ub[i]) + setflag[i] = 1; } /* ---------------------------------------------------------------------- */ @@ -618,6 +704,8 @@ double AngleAmoeba::equilibrium_angle(int i) void AngleAmoeba::write_restart(FILE *fp) { fwrite(&pflag[1],sizeof(int),atom->nangletypes,fp); + fwrite(&ubflag[1],sizeof(int),atom->nangletypes,fp); + fwrite(&theta0[1],sizeof(double),atom->nangletypes,fp); fwrite(&k2[1],sizeof(double),atom->nangletypes,fp); fwrite(&k3[1],sizeof(double),atom->nangletypes,fp); @@ -629,6 +717,9 @@ void AngleAmoeba::write_restart(FILE *fp) fwrite(&ba_k2[1],sizeof(double),atom->nangletypes,fp); fwrite(&ba_r1[1],sizeof(double),atom->nangletypes,fp); fwrite(&ba_r2[1],sizeof(double),atom->nangletypes,fp); + + fwrite(&ub_k[1],sizeof(double),atom->nangletypes,fp); + fwrite(&ub_r0[1],sizeof(double),atom->nangletypes,fp); } /* ---------------------------------------------------------------------- @@ -641,20 +732,34 @@ void AngleAmoeba::read_restart(FILE *fp) if (comm->me == 0) { utils::sfread(FLERR,&pflag[1],sizeof(int),atom->nangletypes,fp,nullptr,error); - utils::sfread(FLERR,&theta0[1],sizeof(double),atom->nangletypes,fp,nullptr,error); + utils::sfread(FLERR,&ubflag[1],sizeof(int),atom->nangletypes, + fp,nullptr,error); + + utils::sfread(FLERR,&theta0[1],sizeof(double),atom->nangletypes, + fp,nullptr,error); utils::sfread(FLERR,&k2[1],sizeof(double),atom->nangletypes,fp,nullptr,error); utils::sfread(FLERR,&k3[1],sizeof(double),atom->nangletypes,fp,nullptr,error); utils::sfread(FLERR,&k4[1],sizeof(double),atom->nangletypes,fp,nullptr,error); utils::sfread(FLERR,&k5[1],sizeof(double),atom->nangletypes,fp,nullptr,error); utils::sfread(FLERR,&k6[1],sizeof(double),atom->nangletypes,fp,nullptr,error); - utils::sfread(FLERR,&ba_k1[1],sizeof(double),atom->nangletypes,fp,nullptr,error); - utils::sfread(FLERR,&ba_k2[1],sizeof(double),atom->nangletypes,fp,nullptr,error); - utils::sfread(FLERR,&ba_r1[1],sizeof(double),atom->nangletypes,fp,nullptr,error); - utils::sfread(FLERR,&ba_r2[1],sizeof(double),atom->nangletypes,fp,nullptr,error); + utils::sfread(FLERR,&ba_k1[1],sizeof(double),atom->nangletypes, + fp,nullptr,error); + utils::sfread(FLERR,&ba_k2[1],sizeof(double),atom->nangletypes, + fp,nullptr,error); + utils::sfread(FLERR,&ba_r1[1],sizeof(double),atom->nangletypes, + fp,nullptr,error); + utils::sfread(FLERR,&ba_r2[1],sizeof(double),atom->nangletypes, + fp,nullptr,error); + + utils::sfread(FLERR,&ub_k[1],sizeof(double),atom->nangletypes, + fp,nullptr,error); + utils::sfread(FLERR,&ub_r0[1],sizeof(double),atom->nangletypes, + fp,nullptr,error); } MPI_Bcast(&pflag[1],atom->nangletypes,MPI_INT,0,world); + MPI_Bcast(&ubflag[1],atom->nangletypes,MPI_INT,0,world); MPI_Bcast(&theta0[1],atom->nangletypes,MPI_DOUBLE,0,world); MPI_Bcast(&k2[1],atom->nangletypes,MPI_DOUBLE,0,world); MPI_Bcast(&k3[1],atom->nangletypes,MPI_DOUBLE,0,world); @@ -667,6 +772,9 @@ void AngleAmoeba::read_restart(FILE *fp) MPI_Bcast(&ba_r1[1],atom->nangletypes,MPI_DOUBLE,0,world); MPI_Bcast(&ba_r2[1],atom->nangletypes,MPI_DOUBLE,0,world); + MPI_Bcast(&ub_k[1],atom->nangletypes,MPI_DOUBLE,0,world); + MPI_Bcast(&ub_r0[1],atom->nangletypes,MPI_DOUBLE,0,world); + for (int i = 1; i <= atom->nangletypes; i++) setflag[i] = 1; } @@ -677,12 +785,17 @@ void AngleAmoeba::read_restart(FILE *fp) void AngleAmoeba::write_data(FILE *fp) { for (int i = 1; i <= atom->nangletypes; i++) - fprintf(fp,"%d %d %g %g %g %g %g %g\n", - i,pflag[i],theta0[i]/MY_PI*180.0,k2[i],k3[i],k4[i],k5[i],k6[i]); + fprintf(fp,"%d %d %d %g %g %g %g %g %g\n", + i,pflag[i],ubflag[i],theta0[i]/MY_PI*180.0, + k2[i],k3[i],k4[i],k5[i],k6[i]); fprintf(fp,"\nBondAngle Coeffs\n\n"); for (int i = 1; i <= atom->nangletypes; i++) fprintf(fp,"%d %g %g %g %g\n",i,ba_k1[i],ba_k2[i],ba_r1[i],ba_r2[i]); + + fprintf(fp,"\nUreyBradley Coeffs\n\n"); + for (int i = 1; i <= atom->nangletypes; i++) + fprintf(fp,"%d %g %g\n",i,ub_k[i],ub_r0[i]); } /* ---------------------------------------------------------------------- */ @@ -726,5 +839,7 @@ double AngleAmoeba::single(int type, int i1, int i2, int i3) double dr2 = r2 - ba_r2[type]; energy += ba_k1[type]*dr1*dtheta + ba_k2[type]*dr2*dtheta; + // NOTE: add UB term + return energy; } diff --git a/src/AMOEBA/angle_amoeba.h b/src/AMOEBA/angle_amoeba.h index 59160c02bd..69a782b48b 100644 --- a/src/AMOEBA/angle_amoeba.h +++ b/src/AMOEBA/angle_amoeba.h @@ -37,14 +37,16 @@ class AngleAmoeba : public Angle { double single(int, int, int, int); protected: - int *pflag; + int *pflag, *ubflag; double *theta0, *k2, *k3, *k4, *k5, *k6; double *ba_k1, *ba_k2, *ba_r1, *ba_r2; - int *setflag_a, *setflag_ba; + double *ub_k, *ub_r0; + int *setflag_a, *setflag_ba, *setflag_ub; void tinker_angle(int, int, int, int, int); void tinker_anglep(int, int, int, int, int); void tinker_bondangle(int, int, int, int, int); + void tinker_urey_bradley(int, int, int, int); void allocate(); }; diff --git a/tools/tinker/data.py b/tools/tinker/data.py index b8c0e284a1..357450536b 100644 --- a/tools/tinker/data.py +++ b/tools/tinker/data.py @@ -372,6 +372,7 @@ skeywords = [["Masses","atom types"], ["PiTorsion Coeffs","pitorsion types"], ["BondBond Coeffs","angle types"], ["BondAngle Coeffs","angle types"], + ["UreyBradley Coeffs","angle types"], ["MiddleBondTorsion Coeffs","dihedral types"], ["EndBondTorsion Coeffs","dihedral types"], ["AngleTorsion Coeffs","dihedral types"], diff --git a/tools/tinker/tinker2lmp.py b/tools/tinker/tinker2lmp.py index ba7008e4ea..95e0013e91 100644 --- a/tools/tinker/tinker2lmp.py +++ b/tools/tinker/tinker2lmp.py @@ -206,6 +206,7 @@ class PRMfile: def angles(self): r2d = 180.0 / math.pi + ubflag = 0 params = [] iline = self.find_section("Angle Bending Parameters") if iline < 0: return params @@ -236,17 +237,17 @@ class PRMfile: lmp5 = self.angle_pentic * value1 * r2d*r2d*r2d lmp6 = self.angle_sextic * value1 * r2d*r2d*r2d*r2d - option1 = (pflag,lmp1,lmp2,lmp3,lmp4,lmp5,lmp6) + option1 = (pflag,ubflag,lmp1,lmp2,lmp3,lmp4,lmp5,lmp6) if len(words) >= 7: value3 = float(words[6]) lmp1 = value3 - option2 = (pflag,lmp1,lmp2,lmp3,lmp4,lmp5,lmp6) + option2 = (pflag,ubflag,lmp1,lmp2,lmp3,lmp4,lmp5,lmp6) if len(words) == 8: value4 = float(words[7]) lmp1 = value4 - option3 = (pflag,lmp1,lmp2,lmp3,lmp4,lmp5,lmp6) + option3 = (pflag,ubflag,lmp1,lmp2,lmp3,lmp4,lmp5,lmp6) if not option2 and not option3: params.append((class1,class2,class3,[option1])) @@ -272,7 +273,7 @@ class PRMfile: bdict = {} for m,bparams in enumerate(self.bondparams): bdict[(bparams[0],bparams[1])] = bparams[2] - + while iline < self.nlines: words = self.lines[iline].split() if len(words): @@ -372,7 +373,7 @@ class PRMfile: iline += 1 return params - # convert PRMfile params to LAMMPS bond_style class2 bond params + # convert PRMfile params to LAMMPS angle_style amoeba UB params # coeffs for K2,K3 = 0.0 since Urey-Bradley is simple harmonic def ureybonds(self): @@ -394,7 +395,7 @@ class PRMfile: lmp1 = value1 lmp2 = value2 - params.append((class1,class2,class3,lmp1,lmp2,0.0,0.0)) + params.append((class1,class2,class3,lmp1,lmp2)) iline += 1 return params @@ -715,6 +716,10 @@ for atom1 in id: pitorsionlist.append((atom3,atom4,atom1,atom2,atom5,atom6)) +# DEBUG - if uncommented, no PiTorsions appear in data file + +pitorsionlist = [] + # ---------------------------------------- # create lists of bond/angle/dihedral/improper types # ---------------------------------------- @@ -754,44 +759,6 @@ for atom1,atom2 in blist: bparams.append((v1,v2,v3,v4)) flags[m] = len(bparams) btype.append(flags[m]) - -# extend btype and bparams with Urey-Bradley H-H bond info -# loop over ublist of UB bonds -# convert prm.ureyparams to a dictionary for efficient searching -# key = (class1,class2,class3) -# value = (M,params) where M is index into prm.ureyparams -# also add the c1,c3 H-H bond to blist - -id = xyz.id -type = xyz.type -classes = prm.classes - -ubdict = {} -for m,params in enumerate(prm.ureyparams): - ubdict[(params[0],params[1],params[2])] = (m,params) - -flags = len(prm.ureyparams)*[0] - -for atom1,atom2,atom3 in ublist: - type1 = type[atom1-1] - type2 = type[atom2-1] - type3 = type[atom3-1] - c1 = classes[type1-1] - c2 = classes[type2-1] - c3 = classes[type3-1] - - if (c1,c2,c3) in ubdict: - m,params = ubdict[(c1,c2,c3)] - blist.append((atom1,atom3)) - elif (c3,c2,c1) in ubdict: - m,params = ubdict[(c3,c2,c1)] - blist.append((atom3,atom1)) - - if not flags[m]: - v1,v2,v3,v4 = params[3:] - bparams.append((v1,v2,v3,v4)) - flags[m] = len(bparams) - btype.append(flags[m]) # generate atype = LAMMPS type of each angle # generate aparams = LAMMPS params for each angle type @@ -905,19 +872,19 @@ for i,one in enumerate(alist): error("Angle not found: %d %d %d: %d %d %d" % (atom1,atom2,atom3,c1,c2,c3)) if not flags[m]: - pflag,v1,v2,v3,v4,v5,v6 = params[3][which-1] - aparams.append((pflag,v1,v2,v3,v4,v5,v6)) + pflag,ubflag,v1,v2,v3,v4,v5,v6 = params[3][which-1] + aparams.append((pflag,ubflag,v1,v2,v3,v4,v5,v6)) flags[m] = len(aparams) atype.append(flags[m]) # augment the aparams with bond-angle cross terms from bondangleparams # generate baparams = LAMMPS bond-angle params for each angle type -# sbdict = dictionary for angle tuples in bongangleparams +# badict = dictionary for angle tuples in bongangleparams -sbdict = {} +badict = {} for v1,v2,v3,v4,v5,v6,v7 in prm.bondangleparams: - if (v1,v2,v3) in sbdict: continue - sbdict[(v1,v2,v3)] = (v4,v5,v6,v7) + if (v1,v2,v3) in badict: continue + badict[(v1,v2,v3)] = (v4,v5,v6,v7) baparams = [] @@ -931,16 +898,54 @@ for itype in range(len(aparams)): c2 = classes[type2-1] c3 = classes[type3-1] - if (c1,c2,c3) in sbdict: - n1,n2,r1,r2 = sbdict[(c1,c2,c3)] - elif (c3,c2,c1) in sbdict: - n1,n2,r1,r2 = sbdict[(c3,c2,c1)] + if (c1,c2,c3) in badict: + n1,n2,r1,r2 = badict[(c1,c2,c3)] + elif (c3,c2,c1) in badict: + n1,n2,r1,r2 = badict[(c3,c2,c1)] else: print "Bond-stretch angle triplet not found: %d %d %d" % (c1,c2,c3) n1,n2,r1,r2 = 4*[0.0] baparams.append((n1,n2,r1,r2)) +# augment the aparams with Urey_Bradley terms from ureyparams +# generate ubparams = LAMMPS UB params for 1-3 bond in each angle type +# ubdict = dictionary for angle tuples in ureyparams + +ubdict = {} +for v1,v2,v3,v4,v5 in prm.ureyparams: + if (v1,v2,v3) in ubdict: continue + ubdict[(v1,v2,v3)] = (v4,v5) + +ubparams = [] + +for itype in range(len(aparams)): + iangle = atype.index(itype+1) + atom1,atom2,atom3 = alist[iangle] + type1 = type[atom1-1] + type2 = type[atom2-1] + type3 = type[atom3-1] + c1 = classes[type1-1] + c2 = classes[type2-1] + c3 = classes[type3-1] + + # if UB settings exist for this angle type, set ubflag in aparams to 1 + + if (c1,c2,c3) in ubdict: + r1,r2 = ubdict[(c1,c2,c3)] + pflag,ubflag,v1,v2,v3,v4,v5,v6 = aparams[itype] + ubflag = 1 + aparams[itype] = (pflag,ubflag,v1,v2,v3,v4,v5,v6) + elif (c3,c2,c1) in ubdict: + r1,r2 = ubdict[(c3,c2,c1)] + pflag,ubflag,v1,v2,v3,v4,v5,v6 = aparams[itype] + ubflag = 1 + aparams[itype] = (pflag,ubflag,v1,v2,v3,v4,v5,v6) + else: + r1,r2 = 2*[0.0] + + ubparams.append((r1,r2)) + # generate dtype = LAMMPS type of each dihedral # generate dparams = LAMMPS params for each dihedral type # flags[i] = which LAMMPS dihedral type (1-N) the Tinker FF file dihedral I is @@ -1075,7 +1080,7 @@ for tmp1,tmp2,atom1,atom2,tmp3,tmp4 in pitorsionlist: print "PRM pitor param",len(prm.pitorsionparams) print "PiTor list",len(pitorsionlist) -print "Flags",flags +#print "Flags",flags # ---------------------------------------- # assign each atom to a Tinker group @@ -1202,6 +1207,13 @@ if nangles: lines.append(line+'\n') d.sections["BondAngle Coeffs"] = lines + lines = [] + for i,one in enumerate(ubparams): + strone = [str(single) for single in one] + line = "%d %s" % (i+1,' '.join(strone)) + lines.append(line+'\n') + d.sections["UreyBradley Coeffs"] = lines + lines = [] for i,one in enumerate(alist): line = "%d %d %d %d %d" % (i+1,atype[i],one[0],one[1],one[2]) From c62f6a3ad01249981f919e65a64867b4d08d7cd8 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Tue, 8 Mar 2022 13:28:54 -0700 Subject: [PATCH 077/585] remove a data file with UB bonds --- examples/amoeba/data.ubiquitin.ub | 29069 ---------------------------- 1 file changed, 29069 deletions(-) delete mode 100644 examples/amoeba/data.ubiquitin.ub diff --git a/examples/amoeba/data.ubiquitin.ub b/examples/amoeba/data.ubiquitin.ub deleted file mode 100644 index 361291cdd4..0000000000 --- a/examples/amoeba/data.ubiquitin.ub +++ /dev/null @@ -1,29069 +0,0 @@ -LAMMPS data file created from Tinker ubiquitin.xyz and amoeba_ubiquitin.prm files - -9737 atoms -9743 bonds -5094 angles -3297 dihedrals -651 impropers -6 atom types -49 bond types -111 angle types -189 dihedral types -33 improper types -0 54.99 xlo xhi -0 41.91 ylo yhi -0 41.91 zlo zhi - -Masses - -1 14.003 -2 12.0 -3 15.995 -4 1.008 -5 31.972 -6 15.999 - -Atoms - -1 1 1 0 9.963103 5.604761 0.008413 -2 1 2 0 9.595854 5.616857 -1.387669 -3 1 2 0 8.190092 6.079015 -1.537478 -4 1 3 0 7.228002 5.276741 -1.343729 -5 1 4 0 9.248539 5.324856 0.671238 -6 1 4 0 10.310756 6.543175 0.309331 -7 1 4 0 10.709289 4.952168 0.170763 -8 1 4 0 10.342605 6.385672 -1.876827 -9 1 2 0 9.777424 4.134312 -1.928716 -10 1 2 0 9.485635 3.817581 -3.412559 -11 1 5 0 10.117567 2.116666 -3.905314 -12 1 2 0 9.214556 1.102048 -2.698793 -13 1 4 0 8.995937 3.481218 -1.313618 -14 1 4 0 10.813555 3.756529 -1.729292 -15 1 4 0 10.074410 4.479912 -4.109344 -16 1 4 0 8.425285 3.844015 -3.623677 -17 1 4 0 9.476005 1.466410 -1.683717 -18 1 4 0 9.531462 0.065851 -2.728696 -19 1 4 0 8.157703 1.221346 -2.837348 -20 1 1 0 8.075651 7.407997 -1.589694 -21 1 2 0 6.846787 8.085212 -1.711474 -22 1 2 0 6.189365 7.484141 -3.005186 -23 1 3 0 6.734597 7.675309 -4.068223 -24 1 4 0 8.951370 7.929371 -1.808185 -25 1 4 0 6.170991 7.786742 -0.821099 -26 1 2 0 7.045430 9.684350 -1.731240 -27 1 2 0 5.783147 10.543682 -1.755861 -28 1 2 0 4.878227 10.489051 -3.011941 -29 1 3 0 5.100354 11.293553 -3.954911 -30 1 1 0 3.787647 9.697542 -2.965312 -31 1 4 0 7.774130 9.919050 -2.476360 -32 1 4 0 7.651586 10.027873 -0.831299 -33 1 4 0 6.211664 11.592747 -1.874653 -34 1 4 0 5.241990 10.447103 -0.794638 -35 1 4 0 3.649816 9.134508 -2.112027 -36 1 4 0 3.185263 9.534971 -3.811678 -37 1 1 0 5.036494 6.768214 -2.882880 -38 1 2 0 4.174197 6.305367 -3.990075 -39 1 2 0 2.728098 6.643573 -3.679890 -40 1 3 0 2.485580 7.278505 -2.662964 -41 1 4 0 4.569007 6.922928 -2.037115 -42 1 4 0 4.411152 6.930990 -4.873795 -43 1 2 0 4.308955 4.772244 -4.223706 -44 1 2 0 3.611944 3.837131 -3.115456 -45 1 2 0 5.819814 4.327532 -4.394409 -46 1 2 0 3.741844 2.375632 -3.462760 -47 1 4 0 3.791883 4.511448 -5.208449 -48 1 4 0 2.547744 4.084411 -3.073934 -49 1 4 0 4.014866 4.138283 -2.115089 -50 1 4 0 6.389594 4.495961 -3.449963 -51 1 4 0 6.367709 4.976173 -5.128547 -52 1 4 0 5.908880 3.195479 -4.756566 -53 1 4 0 3.393827 2.185310 -4.536109 -54 1 4 0 3.102312 1.694874 -2.887955 -55 1 4 0 4.760146 2.000072 -3.426085 -56 1 1 0 1.684147 6.367185 -4.575190 -57 1 2 0 0.304736 6.655628 -4.231748 -58 1 2 0 -0.626185 5.414986 -4.519968 -59 1 3 0 -0.188430 4.481000 -5.239972 -60 1 4 0 1.811341 5.682101 -5.345446 -61 1 4 0 0.263980 6.686032 -3.118862 -62 1 2 0 -0.297187 7.876289 -4.967331 -63 1 2 0 0.656467 9.081574 -5.199077 -64 1 2 0 1.564880 9.231158 -6.344247 -65 1 2 0 0.518242 10.180719 -4.311011 -66 1 2 0 2.254905 10.428397 -6.564398 -67 1 2 0 1.266077 11.295338 -4.552651 -68 1 2 0 2.142006 11.455092 -5.583064 -69 1 4 0 -1.140556 8.280905 -4.296048 -70 1 4 0 -0.810414 7.566064 -5.884866 -71 1 4 0 1.670266 8.406033 -7.077975 -72 1 4 0 -0.165699 10.178758 -3.490791 -73 1 4 0 2.904650 10.539850 -7.451626 -74 1 4 0 1.204400 12.095766 -3.710976 -75 1 4 0 2.760015 12.463610 -5.750178 -76 1 1 0 -1.919463 5.547799 -4.105657 -77 1 2 0 -3.045010 4.631011 -4.380927 -78 1 2 0 -4.206191 5.442932 -4.923986 -79 1 3 0 -4.727895 6.299647 -4.174539 -80 1 4 0 -2.189033 6.454364 -3.576690 -81 1 4 0 -2.684685 3.831124 -5.207150 -82 1 2 0 -3.444418 3.799031 -3.130661 -83 1 2 0 -4.638073 2.796605 -3.426800 -84 1 2 0 -2.172636 3.025555 -2.692910 -85 1 4 0 -3.669812 4.518348 -2.290701 -86 1 4 0 -4.428840 2.137544 -4.376863 -87 1 4 0 -5.534299 3.436652 -3.543248 -88 1 4 0 -4.789185 2.176325 -2.494354 -89 1 4 0 -1.667617 3.522055 -1.846039 -90 1 4 0 -1.416445 2.861139 -3.471806 -91 1 4 0 -2.413054 1.986644 -2.328475 -92 1 1 0 -4.550673 5.196731 -6.274871 -93 1 2 0 -5.820881 5.714130 -6.792896 -94 1 2 0 -6.901797 4.657281 -6.559257 -95 1 3 0 -6.707326 3.538748 -6.976520 -96 1 4 0 -4.247417 4.330282 -6.731623 -97 1 4 0 -6.018895 6.628095 -6.157881 -98 1 2 0 -5.786797 6.030910 -8.386430 -99 1 2 0 -7.031253 6.879587 -8.916479 -100 1 2 0 -6.946629 7.328107 -10.409836 -101 1 2 0 -6.782582 6.224048 -11.537592 -102 1 1 0 -6.791739 6.775547 -12.918869 -103 1 4 0 -5.650656 5.119864 -8.896094 -104 1 4 0 -4.894535 6.632893 -8.720825 -105 1 4 0 -7.188700 7.743879 -8.218707 -106 1 4 0 -7.899583 6.225721 -8.760371 -107 1 4 0 -5.985957 7.986594 -10.510771 -108 1 4 0 -7.792216 7.961266 -10.639952 -109 1 4 0 -7.448325 5.332480 -11.448147 -110 1 4 0 -5.800269 5.666745 -11.336805 -111 1 4 0 -5.991776 7.279636 -13.178670 -112 1 4 0 -7.621495 7.404931 -13.058222 -113 1 4 0 -6.983504 6.085979 -13.693073 -114 1 1 0 -8.069363 5.037776 -5.939754 -115 1 2 0 -9.334342 4.259320 -5.870215 -116 1 2 0 -10.106400 4.390027 -7.235984 -117 1 3 0 -9.678872 5.138872 -8.064541 -118 1 4 0 -8.065341 5.988423 -5.484094 -119 1 4 0 -9.057846 3.167719 -5.835950 -120 1 2 0 -10.266512 4.660993 -4.660344 -121 1 3 0 -10.534149 6.114601 -4.706758 -122 1 2 0 -9.745157 4.269631 -3.191928 -123 1 4 0 -11.263017 4.131676 -4.781723 -124 1 4 0 -9.713871 6.599029 -4.391676 -125 1 4 0 -9.116723 4.972749 -2.508566 -126 1 4 0 -9.168034 3.361328 -3.330127 -127 1 4 0 -10.522836 3.973872 -2.499829 -128 1 1 0 -11.233860 3.687218 -7.306137 -129 1 2 0 -12.200193 3.653311 -8.374575 -130 1 2 0 -13.220650 4.788154 -8.169599 -131 1 3 0 -13.737841 5.372844 -9.165473 -132 1 4 0 -11.460538 2.988105 -6.540266 -133 1 4 0 -11.637688 3.949136 -9.406377 -134 1 2 0 -12.914543 2.186268 -8.423705 -135 1 2 0 -12.050888 0.859767 -8.189045 -136 1 2 0 -12.754212 -0.443223 -8.481524 -137 1 2 0 -10.761720 0.854864 -8.962914 -138 1 4 0 -13.378342 2.203311 -9.441391 -139 1 4 0 -13.731396 2.273518 -7.697910 -140 1 4 0 -11.784384 0.837730 -7.097584 -141 1 4 0 -12.178199 -1.386252 -8.511713 -142 1 4 0 -13.030296 -0.361584 -9.541647 -143 1 4 0 -13.665537 -0.574300 -7.888432 -144 1 4 0 -10.907312 0.853311 -10.020395 -145 1 4 0 -10.166450 -0.087962 -8.625340 -146 1 4 0 -10.131655 1.808766 -8.717686 -147 1 1 0 -13.463568 5.196109 -6.936262 -148 1 2 0 -14.321525 6.337206 -6.640073 -149 1 2 0 -13.602436 7.749411 -6.813046 -150 1 3 0 -14.285287 8.753093 -7.068264 -151 1 4 0 -13.224563 4.686522 -6.108713 -152 1 4 0 -15.116925 6.447123 -7.471724 -153 1 2 0 -15.130805 6.126006 -5.300665 -154 1 3 0 -14.245708 5.884444 -4.246742 -155 1 2 0 -16.085304 4.854769 -5.370470 -156 1 4 0 -15.668029 7.073411 -5.139360 -157 1 4 0 -13.863528 6.745981 -4.031876 -158 1 4 0 -16.931480 4.985645 -6.114646 -159 1 4 0 -16.633409 4.776539 -4.392875 -160 1 4 0 -15.447009 3.996959 -5.527187 -161 1 1 0 -12.255780 7.804163 -6.773987 -162 1 2 0 -11.475822 9.029360 -6.961862 -163 1 2 0 -10.482668 9.429993 -5.875126 -164 1 3 0 -9.615012 10.212498 -6.150085 -165 1 4 0 -11.791631 6.946169 -6.476230 -166 1 4 0 -10.849439 8.869550 -7.825758 -167 1 4 0 -12.070294 9.912283 -7.089554 -168 1 1 0 -10.710240 8.937450 -4.551265 -169 1 2 0 -9.795182 9.275190 -3.486218 -170 1 2 0 -8.432503 8.733444 -3.903900 -171 1 3 0 -8.256860 7.497941 -4.141932 -172 1 4 0 -11.613017 8.458729 -4.378865 -173 1 4 0 -9.758201 10.415786 -3.586213 -174 1 2 0 -10.207682 8.847560 -2.068515 -175 1 2 0 -9.468868 9.640494 -0.969458 -176 1 2 0 -9.960726 11.106750 -0.880514 -177 1 2 0 -8.996147 11.882980 0.056845 -178 1 1 0 -9.422979 13.246330 0.389189 -179 1 4 0 -10.025076 7.711214 -1.993654 -180 1 4 0 -11.260829 8.969143 -1.909413 -181 1 4 0 -8.357381 9.561485 -1.037070 -182 1 4 0 -9.831062 9.156523 0.052119 -183 1 4 0 -10.951565 11.152527 -0.421834 -184 1 4 0 -10.025528 11.645570 -1.861235 -185 1 4 0 -7.996392 12.007902 -0.493686 -186 1 4 0 -8.903714 11.241749 1.019391 -187 1 4 0 -9.372439 13.931515 -0.356496 -188 1 4 0 -8.869279 13.642636 1.216690 -189 1 4 0 -10.417962 13.346471 0.725918 -190 1 1 0 -7.417712 9.626751 -3.887457 -191 1 2 0 -6.048686 9.319758 -4.265281 -192 1 2 0 -5.195256 9.655954 -3.012996 -193 1 3 0 -5.383682 10.790154 -2.469855 -194 1 4 0 -7.536192 10.638944 -3.603417 -195 1 4 0 -5.899497 8.237555 -4.489940 -196 1 2 0 -5.632346 10.139153 -5.558621 -197 1 3 0 -6.651850 9.845307 -6.610520 -198 1 2 0 -4.307909 9.733791 -6.252541 -199 1 4 0 -5.546957 11.240303 -5.391676 -200 1 4 0 -7.479446 10.239776 -6.352124 -201 1 4 0 -4.057722 10.346459 -7.141293 -202 1 4 0 -4.216816 8.651918 -6.414903 -203 1 4 0 -3.513698 9.947681 -5.542599 -204 1 1 0 -4.487761 8.698281 -2.479508 -205 1 2 0 -3.941682 8.719222 -1.101838 -206 1 2 0 -2.471661 8.338585 -1.186861 -207 1 3 0 -2.098577 7.337481 -1.795680 -208 1 4 0 -4.371107 7.734334 -2.775858 -209 1 4 0 -3.985516 9.750968 -0.737465 -210 1 2 0 -4.697768 7.852820 -0.064484 -211 1 2 0 -4.708913 6.295035 -0.438982 -212 1 2 0 -6.123205 8.316839 0.212195 -213 1 2 0 -5.620903 5.382941 0.512646 -214 1 4 0 -4.057362 7.911400 0.860642 -215 1 4 0 -3.677285 5.838816 -0.381317 -216 1 4 0 -5.097879 6.136516 -1.456773 -217 1 4 0 -6.958332 8.061232 -0.486042 -218 1 4 0 -6.120750 9.492014 0.254246 -219 1 4 0 -6.463653 8.052122 1.235972 -220 1 4 0 -6.708420 5.577546 0.309314 -221 1 4 0 -5.353714 5.729677 1.560568 -222 1 4 0 -5.449967 4.323238 0.397743 -223 1 1 0 -1.597496 9.147378 -0.364603 -224 1 2 0 -0.135695 9.298656 -0.268971 -225 1 2 0 0.407838 8.259131 0.762984 -226 1 3 0 -0.125678 8.256398 1.864934 -227 1 4 0 -2.061490 9.698188 0.341812 -228 1 4 0 0.291486 9.062300 -1.222284 -229 1 2 0 0.359683 10.712136 0.203065 -230 1 3 0 -0.513535 11.802509 -0.157986 -231 1 2 0 1.661404 11.100111 -0.496546 -232 1 4 0 0.487415 10.613723 1.289529 -233 1 4 0 -0.894682 12.193680 0.613553 -234 1 4 0 1.924560 12.095482 -0.170163 -235 1 4 0 1.527624 11.126022 -1.612055 -236 1 4 0 2.524096 10.406872 -0.273554 -237 1 1 0 1.458638 7.533911 0.367476 -238 1 2 0 2.250809 6.653110 1.155065 -239 1 2 0 3.767103 6.967571 0.917085 -240 1 3 0 4.150469 7.414883 -0.134304 -241 1 4 0 1.800100 7.626011 -0.603649 -242 1 4 0 1.984132 6.848652 2.199761 -243 1 2 0 1.985932 5.208560 0.673411 -244 1 2 0 0.499001 4.775460 0.950638 -245 1 2 0 0.302449 3.382258 0.307039 -246 1 2 0 0.318833 4.590905 2.467625 -247 1 4 0 2.620352 4.479840 1.153057 -248 1 4 0 2.170192 5.140748 -0.421262 -249 1 4 0 -0.141837 5.460611 0.448133 -250 1 4 0 -0.765868 3.158508 0.337643 -251 1 4 0 0.881511 2.586559 0.876485 -252 1 4 0 0.635114 3.382961 -0.727832 -253 1 4 0 0.991181 3.809378 2.860913 -254 1 4 0 -0.810422 4.305406 2.724253 -255 1 4 0 0.495432 5.527245 3.085307 -256 1 1 0 4.493868 6.668739 2.051013 -257 1 2 0 5.977452 6.826187 2.081574 -258 1 2 0 6.574479 5.473810 2.542943 -259 1 3 0 7.539223 5.437653 3.331859 -260 1 4 0 4.101906 6.335458 2.916399 -261 1 4 0 6.354091 6.853748 1.027532 -262 1 2 0 6.470006 8.005228 2.962480 -263 1 2 0 6.523156 9.385148 2.265263 -264 1 2 0 6.660389 10.531119 3.176475 -265 1 3 0 7.818717 10.946737 3.494784 -266 1 3 0 5.641727 11.057335 3.676704 -267 1 4 0 7.426538 7.872313 3.417016 -268 1 4 0 5.818378 7.862045 3.841666 -269 1 4 0 5.562369 9.490953 1.596644 -270 1 4 0 7.296811 9.382149 1.478494 -271 1 1 0 6.080956 4.317668 2.172588 -272 1 2 0 6.395184 2.914756 2.360428 -273 1 2 0 7.756330 2.626277 1.796235 -274 1 3 0 8.336336 3.369371 0.946953 -275 1 4 0 5.286582 4.431259 1.580017 -276 1 4 0 6.544551 2.775770 3.450173 -277 1 2 0 5.254270 2.029334 1.828047 -278 1 2 0 3.855516 2.115298 2.663831 -279 1 2 0 4.878513 2.275077 0.297641 -280 1 4 0 5.659978 0.937168 1.997214 -281 1 4 0 3.988977 1.632132 3.721066 -282 1 4 0 3.154094 1.488836 2.202125 -283 1 4 0 3.518024 3.208135 2.707458 -284 1 4 0 4.391723 3.244259 0.119355 -285 1 4 0 4.197460 1.515591 -0.214541 -286 1 4 0 5.820024 2.281294 -0.232189 -287 1 1 0 8.439412 1.532076 2.306730 -288 1 2 0 9.766718 1.104522 1.810124 -289 1 2 0 9.609640 -0.146333 0.921245 -290 1 3 0 8.595667 -0.823014 1.060066 -291 1 4 0 7.906057 0.817610 2.769235 -292 1 4 0 10.402589 1.878772 1.340853 -293 1 2 0 10.623245 0.647963 3.024596 -294 1 2 0 11.099332 1.681203 4.040791 -295 1 2 0 12.471923 2.276164 3.591284 -296 1 3 0 13.467460 1.635754 4.022756 -297 1 3 0 12.447093 3.241865 2.732975 -298 1 4 0 11.464087 0.045385 2.632771 -299 1 4 0 10.035308 -0.165388 3.606999 -300 1 4 0 11.283249 1.117646 5.042705 -301 1 4 0 10.341030 2.493195 4.310498 -302 1 1 0 10.649425 -0.442448 0.039711 -303 1 2 0 10.721650 -1.691625 -0.719097 -304 1 2 0 10.688929 -3.019270 0.171469 -305 1 3 0 10.136780 -4.017164 -0.258017 -306 1 4 0 9.824725 -1.703322 -1.331408 -307 1 2 0 12.047830 -1.730137 -1.583772 -308 1 2 0 12.438841 -0.254934 -1.430560 -309 1 2 0 11.880473 0.342410 -0.130781 -310 1 4 0 11.910217 -2.011767 -2.680814 -311 1 4 0 12.740874 -2.453727 -1.101295 -312 1 4 0 12.084519 0.391154 -2.320456 -313 1 4 0 13.550172 -0.165266 -1.345695 -314 1 4 0 11.730541 1.403440 -0.268593 -315 1 4 0 12.568702 0.262680 0.684216 -316 1 1 0 11.185418 -2.821488 1.401909 -317 1 2 0 11.478487 -3.819995 2.417066 -318 1 2 0 10.240507 -4.133695 3.340195 -319 1 3 0 10.437807 -4.944657 4.272068 -320 1 4 0 11.675553 -1.939666 1.629182 -321 1 4 0 11.715305 -4.763029 1.892686 -322 1 2 0 12.726302 -3.441835 3.258589 -323 1 3 0 12.588509 -2.169159 3.871288 -324 1 4 0 13.594515 -3.465914 2.619460 -325 1 4 0 12.919669 -4.225010 4.041833 -326 1 4 0 11.928461 -2.056942 4.572136 -327 1 1 0 8.989610 -3.538327 3.147788 -328 1 2 0 7.780090 -3.809839 3.903153 -329 1 2 0 6.830692 -4.723128 3.182411 -330 1 3 0 6.843975 -4.931536 1.971249 -331 1 4 0 8.790490 -2.959432 2.207143 -332 1 4 0 8.112743 -4.402734 4.754275 -333 1 2 0 7.007696 -2.493713 4.325713 -334 1 2 0 7.757815 -1.793205 5.421557 -335 1 3 0 8.301432 -0.683792 5.213313 -336 1 3 0 8.105449 -2.430264 6.467845 -337 1 4 0 6.015719 -2.736995 4.787540 -338 1 4 0 6.870322 -1.705199 3.554568 -339 1 1 0 5.911537 -5.420074 3.889645 -340 1 2 0 4.985368 -6.339027 3.207488 -341 1 2 0 3.791981 -5.460118 2.675447 -342 1 3 0 3.602436 -4.262217 3.058351 -343 1 4 0 5.945002 -5.355465 4.936544 -344 1 4 0 5.522096 -6.871961 2.401608 -345 1 2 0 4.403843 -7.437211 4.151447 -346 1 3 0 3.984983 -6.837474 5.417872 -347 1 2 0 5.484751 -8.435266 4.460478 -348 1 4 0 3.543374 -7.871125 3.610585 -349 1 4 0 3.626750 -7.635311 5.866975 -350 1 4 0 5.852794 -8.923165 3.576288 -351 1 4 0 5.092476 -9.235700 5.230406 -352 1 4 0 6.347457 -8.009387 5.033245 -353 1 1 0 3.001520 -6.091562 1.873663 -354 1 2 0 1.770212 -5.563203 1.356920 -355 1 2 0 0.721356 -5.331197 2.570590 -356 1 3 0 -0.022158 -4.354859 2.639919 -357 1 4 0 3.312873 -6.951353 1.400664 -358 1 4 0 2.050592 -4.577254 0.922928 -359 1 2 0 1.071972 -6.339450 0.158527 -360 1 2 0 1.737761 -5.960287 -1.242592 -361 1 2 0 -0.457848 -6.189077 0.133627 -362 1 2 0 3.239275 -5.961276 -1.280042 -363 1 4 0 1.324741 -7.458613 0.269568 -364 1 4 0 1.479259 -4.859796 -1.271486 -365 1 4 0 1.361220 -6.531125 -2.132946 -366 1 4 0 -0.903041 -6.854230 -0.657366 -367 1 4 0 -0.782418 -5.132849 -0.071473 -368 1 4 0 -0.922422 -6.573767 1.109124 -369 1 4 0 3.570026 -6.965706 -1.066579 -370 1 4 0 3.783014 -5.330759 -0.595789 -371 1 4 0 3.656696 -5.782972 -2.272787 -372 1 1 0 0.712989 -6.304521 3.584311 -373 1 2 0 0.052790 -6.261661 4.839148 -374 1 2 0 0.191347 -4.895606 5.488007 -375 1 3 0 -0.836031 -4.209177 5.761481 -376 1 4 0 1.234822 -7.176952 3.358561 -377 1 4 0 -1.022887 -6.329021 4.691721 -378 1 2 0 0.463881 -7.420468 5.813551 -379 1 2 0 -0.181732 -7.570702 7.165576 -380 1 2 0 0.007120 -6.414258 8.102713 -381 1 3 0 -0.893307 -5.557057 8.345423 -382 1 3 0 1.071916 -6.451342 8.739901 -383 1 4 0 1.565739 -7.379644 5.945185 -384 1 4 0 0.280894 -8.335875 5.233490 -385 1 4 0 0.223173 -8.515314 7.648734 -386 1 4 0 -1.278836 -7.754581 6.974807 -387 1 1 0 1.506487 -4.494779 5.655260 -388 1 2 0 2.024384 -3.272083 6.150972 -389 1 2 0 1.585880 -2.044887 5.407014 -390 1 3 0 1.072089 -1.054656 5.937784 -391 1 4 0 2.247022 -5.169015 5.381363 -392 1 4 0 1.726295 -3.077017 7.202284 -393 1 2 0 3.519486 -3.297907 6.249706 -394 1 2 0 4.110165 -2.209620 7.106417 -395 1 3 0 4.558866 -1.206675 6.574355 -396 1 1 0 3.975447 -2.353795 8.429417 -397 1 4 0 3.926527 -3.312701 5.199577 -398 1 4 0 3.906987 -4.290859 6.729019 -399 1 4 0 3.351621 -3.100412 8.835262 -400 1 4 0 4.250233 -1.572327 9.095945 -401 1 1 0 1.646215 -2.106555 3.995169 -402 1 2 0 0.960547 -1.056203 3.144271 -403 1 2 0 -0.585323 -0.906494 3.471384 -404 1 3 0 -1.001272 0.221409 3.639638 -405 1 4 0 2.076586 -2.917444 3.633085 -406 1 4 0 1.398083 -0.037330 3.348893 -407 1 2 0 1.148406 -1.421290 1.565953 -408 1 2 0 0.469253 -0.291141 0.677094 -409 1 2 0 2.652804 -1.432319 1.256255 -410 1 4 0 0.776571 -2.470203 1.403081 -411 1 4 0 -0.604778 -0.059927 0.825468 -412 1 4 0 0.696071 -0.403531 -0.364402 -413 1 4 0 0.904174 0.691668 0.985463 -414 1 4 0 2.642691 -1.597766 0.131660 -415 1 4 0 3.137894 -2.381059 1.586216 -416 1 4 0 3.298051 -0.632131 1.598249 -417 1 1 0 -1.305966 -1.988607 3.652565 -418 1 2 0 -2.689415 -1.960736 4.065894 -419 1 2 0 -2.947986 -1.384388 5.464246 -420 1 3 0 -3.956927 -0.687209 5.701440 -421 1 4 0 -0.971106 -2.849328 3.302467 -422 1 4 0 -3.296900 -1.262385 3.382761 -423 1 2 0 -3.427836 -3.412377 3.961933 -424 1 2 0 -3.574171 -3.928612 2.505721 -425 1 2 0 -3.982306 -5.479470 2.370643 -426 1 2 0 -4.137753 -5.916145 0.907307 -427 1 1 0 -4.842456 -7.207476 0.671588 -428 1 4 0 -4.389394 -3.425752 4.550163 -429 1 4 0 -2.806920 -4.163717 4.552623 -430 1 4 0 -2.578225 -3.744348 2.022778 -431 1 4 0 -4.131610 -3.317335 1.794895 -432 1 4 0 -4.944670 -5.685367 2.884988 -433 1 4 0 -3.219699 -6.072549 2.922384 -434 1 4 0 -3.220948 -5.866340 0.240386 -435 1 4 0 -4.886137 -5.224022 0.371600 -436 1 4 0 -4.398637 -8.010724 1.108282 -437 1 4 0 -4.689919 -7.536305 -0.283243 -438 1 4 0 -5.789366 -7.298894 0.961468 -439 1 1 0 -1.966539 -1.653932 6.352370 -440 1 2 0 -1.877059 -1.184384 7.700740 -441 1 2 0 -1.810243 0.352689 7.772527 -442 1 3 0 -2.478130 1.012858 8.630055 -443 1 4 0 -1.296883 -2.342673 6.065841 -444 1 4 0 -2.903503 -1.425619 8.306499 -445 1 2 0 -0.719870 -1.906634 8.460693 -446 1 4 0 -0.392867 -1.394748 9.399750 -447 1 4 0 0.201561 -1.700787 7.931161 -448 1 4 0 -0.824494 -3.016135 8.415257 -449 1 1 0 -1.014819 0.884949 6.873831 -450 1 2 0 -0.928004 2.359933 6.752150 -451 1 2 0 -2.242871 3.020975 6.141860 -452 1 3 0 -2.667293 4.165871 6.497798 -453 1 4 0 -0.255487 0.266534 6.475305 -454 1 4 0 -0.709751 2.767594 7.790539 -455 1 2 0 0.185451 2.818592 5.731872 -456 1 2 0 1.718082 2.368933 6.157097 -457 1 2 0 1.976397 2.630036 7.634372 -458 1 2 0 3.272626 1.811866 8.042755 -459 1 1 0 3.783277 2.119562 9.341763 -460 1 4 0 0.173809 4.017727 5.824418 -461 1 4 0 -0.110843 2.644975 4.655738 -462 1 4 0 2.436177 2.906087 5.459782 -463 1 4 0 1.767963 1.228903 6.013437 -464 1 4 0 1.214734 2.413689 8.372810 -465 1 4 0 2.023085 3.725792 7.759055 -466 1 4 0 4.113891 1.884123 7.336520 -467 1 4 0 2.915132 0.727469 8.065927 -468 1 4 0 3.879659 1.332383 9.938486 -469 1 4 0 3.292027 2.768104 9.893226 -470 1 4 0 4.657654 2.620898 9.415395 -471 1 1 0 -2.951323 2.325118 5.282730 -472 1 2 0 -4.325905 2.722744 4.841568 -473 1 2 0 -5.448579 2.576087 5.910067 -474 1 3 0 -6.209518 3.521045 6.095847 -475 1 4 0 -2.521898 1.551084 4.791650 -476 1 4 0 -4.313051 3.829830 4.708638 -477 1 2 0 -4.631289 2.056947 3.491556 -478 1 2 0 -3.597982 2.356462 2.341899 -479 1 2 0 -6.057287 2.415036 2.978562 -480 1 2 0 -3.795503 1.412901 1.156511 -481 1 4 0 -4.671054 0.937191 3.752299 -482 1 4 0 -2.607674 2.121882 2.680974 -483 1 4 0 -3.588639 3.467984 2.067654 -484 1 4 0 -6.778277 2.127584 3.784506 -485 1 4 0 -6.408690 1.672558 2.286363 -486 1 4 0 -6.257305 3.445522 2.543283 -487 1 4 0 -2.827681 1.370598 0.452926 -488 1 4 0 -4.701905 1.709692 0.600596 -489 1 4 0 -3.968868 0.353877 1.535108 -490 1 1 0 -5.427736 1.517434 6.772139 -491 1 2 0 -6.281638 1.417159 7.917235 -492 1 2 0 -6.135061 2.619316 8.825463 -493 1 3 0 -7.083993 3.050483 9.468967 -494 1 4 0 -4.778187 0.710522 6.592937 -495 1 4 0 -7.347518 1.392997 7.523591 -496 1 2 0 -5.911289 0.089334 8.730160 -497 1 2 0 -6.704804 -0.165892 10.024245 -498 1 2 0 -8.207420 0.060746 9.966819 -499 1 3 0 -8.766731 0.511631 10.987813 -500 1 1 0 -8.851167 -0.577098 8.977765 -501 1 4 0 -4.871800 0.035639 8.932959 -502 1 4 0 -6.099650 -0.797867 8.002499 -503 1 4 0 -6.379603 0.602172 10.795373 -504 1 4 0 -6.514059 -1.228415 10.339368 -505 1 4 0 -8.316985 -1.014678 8.258816 -506 1 4 0 -9.833090 -0.545963 8.919578 -507 1 1 0 -4.878643 3.139322 9.062914 -508 1 2 0 -4.649566 4.328949 9.987955 -509 1 2 0 -4.957775 5.668926 9.413617 -510 1 3 0 -5.630236 6.445624 10.106188 -511 1 4 0 -4.081549 2.846329 8.507102 -512 1 4 0 -5.406537 4.281488 10.784832 -513 1 2 0 -3.243945 4.227889 10.546816 -514 1 2 0 -3.087728 5.171882 11.728346 -515 1 3 0 -4.053576 5.190045 12.600221 -516 1 3 0 -2.058101 5.835943 11.978474 -517 1 4 0 -2.562382 4.521403 9.724738 -518 1 4 0 -2.932032 3.215635 10.964683 -519 1 1 0 -4.878039 5.785317 8.031390 -520 1 2 0 -5.310084 7.089332 7.406389 -521 1 2 0 -6.749125 7.172087 6.971101 -522 1 3 0 -7.405628 8.229614 7.089684 -523 1 4 0 -4.283642 5.091117 7.531729 -524 1 4 0 -5.274077 7.841191 8.198368 -525 1 2 0 -4.287673 7.649544 6.440392 -526 1 2 0 -4.264316 6.824230 5.084233 -527 1 2 0 -3.348184 7.282872 3.940214 -528 1 2 0 -1.862959 6.984827 4.246876 -529 1 1 0 -1.232990 7.951755 5.175746 -530 1 4 0 -3.353989 7.682751 6.978380 -531 1 4 0 -4.577117 8.665353 6.188031 -532 1 4 0 -5.271336 7.010431 4.645228 -533 1 4 0 -4.183939 5.756196 5.214904 -534 1 4 0 -3.478219 8.414723 3.726542 -535 1 4 0 -3.567163 6.665420 3.125679 -536 1 4 0 -1.380469 7.033451 3.200397 -537 1 4 0 -1.658625 5.960828 4.579387 -538 1 4 0 -1.681026 8.865239 5.169898 -539 1 4 0 -0.322832 8.170574 4.811931 -540 1 4 0 -1.120976 7.690090 6.115363 -541 1 1 0 -7.260673 6.129896 6.365283 -542 1 2 0 -8.574938 6.119982 5.731267 -543 1 2 0 -9.544300 5.242356 6.500946 -544 1 3 0 -10.776630 5.341657 6.228564 -545 1 4 0 -6.694313 5.297054 6.084394 -546 1 4 0 -8.965369 7.148290 5.836761 -547 1 2 0 -8.593435 5.700600 4.232465 -548 1 2 0 -8.142917 6.797216 3.313691 -549 1 2 0 -8.922098 8.128550 3.290754 -550 1 3 0 -10.019708 8.282415 2.683597 -551 1 3 0 -8.418377 9.080422 3.962396 -552 1 4 0 -9.637470 5.370747 3.983240 -553 1 4 0 -7.841735 4.791994 4.106244 -554 1 4 0 -7.988334 6.410373 2.240226 -555 1 4 0 -7.108545 7.056748 3.606925 -556 1 1 0 -9.109752 4.287946 7.340476 -557 1 2 0 -10.009860 3.416611 8.055823 -558 1 2 0 -10.705939 2.327979 7.248022 -559 1 3 0 -11.556202 1.623209 7.719085 -560 1 4 0 -8.134437 4.133993 7.462110 -561 1 4 0 -9.403268 2.909131 8.828371 -562 1 4 0 -10.766691 4.008828 8.630570 -563 1 1 0 -10.238426 2.084832 5.988242 -564 1 2 0 -10.830327 1.014314 5.135787 -565 1 2 0 -10.123635 -0.408365 5.490888 -566 1 3 0 -8.886974 -0.473105 5.573450 -567 1 4 0 -9.463779 2.473999 5.471519 -568 1 4 0 -11.972825 0.862184 5.405029 -569 1 2 0 -10.573783 1.408499 3.605155 -570 1 2 0 -11.473874 2.659840 3.274246 -571 1 2 0 -10.768674 0.116838 2.675834 -572 1 2 0 -11.386046 3.100490 1.827956 -573 1 4 0 -9.497664 1.719665 3.575726 -574 1 4 0 -11.189235 3.505368 3.971634 -575 1 4 0 -12.466031 2.387035 3.608591 -576 1 4 0 -10.418619 0.285197 1.650312 -577 1 4 0 -11.889425 -0.154704 2.658339 -578 1 4 0 -10.253412 -0.844191 2.935472 -579 1 4 0 -10.489631 3.687189 1.608836 -580 1 4 0 -12.252949 3.808896 1.730836 -581 1 4 0 -11.600834 2.256313 1.164934 -582 1 1 0 -10.904182 -1.495291 5.769914 -583 1 2 0 -10.294825 -2.685192 6.266115 -584 1 2 0 -9.362686 -3.411747 5.150144 -585 1 3 0 -9.822907 -3.806655 4.048145 -586 1 4 0 -9.678597 -2.483780 7.200705 -587 1 2 0 -11.433893 -3.623279 6.740457 -588 1 2 0 -12.623002 -3.096904 5.800687 -589 1 2 0 -12.355474 -1.596314 5.926055 -590 1 4 0 -11.632975 -3.481644 7.836795 -591 1 4 0 -11.185183 -4.717775 6.760900 -592 1 4 0 -13.676441 -3.284634 6.130235 -593 1 4 0 -12.571296 -3.294434 4.749284 -594 1 4 0 -12.712668 -1.093954 6.983468 -595 1 4 0 -12.878080 -1.082331 5.087665 -596 1 1 0 -8.141305 -3.913338 5.553940 -597 1 2 0 -7.265296 -4.892156 4.877616 -598 1 2 0 -7.954629 -6.074235 4.106746 -599 1 3 0 -7.526189 -6.449816 3.017058 -600 1 4 0 -6.579043 -4.462262 4.120819 -601 1 2 0 -6.340090 -5.386881 5.987491 -602 1 2 0 -6.098980 -4.115508 6.793069 -603 1 2 0 -7.478029 -3.499220 6.819358 -604 1 4 0 -5.439953 -5.907262 5.648183 -605 1 4 0 -6.857707 -6.166813 6.603499 -606 1 4 0 -5.359728 -3.456071 6.338156 -607 1 4 0 -5.774381 -4.378426 7.875984 -608 1 4 0 -7.367742 -2.409829 6.921891 -609 1 4 0 -8.055072 -3.868224 7.656931 -610 1 1 0 -9.008919 -6.608446 4.793434 -611 1 2 0 -9.678181 -7.733135 4.285369 -612 1 2 0 -10.514900 -7.453854 3.062726 -613 1 3 0 -10.598980 -8.267352 2.099054 -614 1 4 0 -9.372380 -6.226786 5.718134 -615 1 4 0 -8.952673 -8.430078 3.800831 -616 1 2 0 -10.385978 -8.504460 5.406790 -617 1 2 0 -11.095963 -9.718862 4.959627 -618 1 3 0 -12.323382 -9.860403 5.304109 -619 1 3 0 -10.342738 -10.617376 4.418998 -620 1 4 0 -11.151852 -7.927877 5.826167 -621 1 4 0 -9.623560 -8.740853 6.193107 -622 1 1 0 -11.049078 -6.202245 2.940419 -623 1 2 0 -11.642018 -5.709443 1.705877 -624 1 2 0 -10.614336 -5.092838 0.713167 -625 1 3 0 -10.927213 -4.951138 -0.459225 -626 1 4 0 -11.081256 -5.587042 3.696816 -627 1 4 0 -11.984075 -6.605539 1.087897 -628 1 2 0 -12.768231 -4.705104 1.983069 -629 1 2 0 -13.883829 -5.316250 2.907105 -630 1 2 0 -15.114338 -4.418666 2.924881 -631 1 3 0 -15.405304 -3.917271 4.026449 -632 1 1 0 -15.906827 -4.358107 1.868346 -633 1 4 0 -13.285557 -4.431812 1.024843 -634 1 4 0 -12.425058 -3.757312 2.498081 -635 1 4 0 -13.493993 -5.422715 3.976146 -636 1 4 0 -14.172955 -6.317959 2.590855 -637 1 4 0 -15.643280 -4.761085 0.943045 -638 1 4 0 -16.887617 -4.110344 2.002905 -639 1 1 0 -9.403516 -4.718671 1.187009 -640 1 2 0 -8.418526 -4.190723 0.263736 -641 1 2 0 -7.842430 -5.239112 -0.660532 -642 1 3 0 -7.328931 -6.262671 -0.141830 -643 1 4 0 -9.039521 -4.862514 2.100989 -644 1 4 0 -8.913388 -3.436668 -0.331077 -645 1 2 0 -7.143827 -3.503558 1.041637 -646 1 2 0 -7.586437 -2.244888 1.828880 -647 1 2 0 -6.397386 -1.503568 2.513414 -648 1 3 0 -5.279630 -1.340947 1.984414 -649 1 1 0 -6.649301 -1.020214 3.747788 -650 1 4 0 -6.392988 -3.161834 0.246377 -651 1 4 0 -6.600747 -4.159050 1.729753 -652 1 4 0 -8.388106 -2.412938 2.663083 -653 1 4 0 -8.063908 -1.554062 1.129126 -654 1 4 0 -7.599327 -0.974932 4.121687 -655 1 4 0 -5.824088 -0.762663 4.379842 -656 1 1 0 -7.975739 -5.085940 -2.051099 -657 1 2 0 -7.316226 -5.859411 -3.099220 -658 1 2 0 -6.535954 -4.884159 -3.940503 -659 1 3 0 -7.016650 -4.323287 -4.885061 -660 1 4 0 -8.649330 -4.421740 -2.442279 -661 1 4 0 -6.552638 -6.577875 -2.549459 -662 1 2 0 -8.293193 -6.657174 -4.000956 -663 1 2 0 -8.951016 -7.920548 -3.205693 -664 1 2 0 -8.120004 -9.231611 -2.981077 -665 1 1 0 -7.224446 -9.317181 -1.844858 -666 1 2 0 -6.456272 -10.352566 -1.540149 -667 1 1 0 -6.261777 -11.358001 -2.422146 -668 1 1 0 -6.102837 -10.524228 -0.288739 -669 1 4 0 -7.757336 -7.047341 -4.904160 -670 1 4 0 -9.163272 -5.963583 -4.290787 -671 1 4 0 -9.924984 -8.240285 -3.732011 -672 1 4 0 -9.185465 -7.539611 -2.167170 -673 1 4 0 -7.474087 -9.426829 -3.909433 -674 1 4 0 -8.804222 -10.092199 -2.813314 -675 1 4 0 -7.241497 -8.530605 -1.089185 -676 1 4 0 -6.629122 -11.380337 -3.383889 -677 1 4 0 -5.815388 -12.216685 -2.108949 -678 1 4 0 -6.430516 -9.899279 0.447997 -679 1 4 0 -5.622476 -11.346782 -0.024111 -680 1 1 0 -5.292942 -4.653337 -3.548836 -681 1 2 0 -4.364875 -3.733621 -4.272520 -682 1 2 0 -3.884056 -4.434009 -5.580010 -683 1 3 0 -3.533279 -5.624908 -5.562725 -684 1 4 0 -4.823372 -5.284331 -2.925755 -685 1 4 0 -4.946353 -2.808529 -4.509708 -686 1 2 0 -3.111739 -3.306714 -3.368632 -687 1 2 0 -3.512923 -2.415189 -2.103271 -688 1 2 0 -2.187524 -2.216424 -1.223893 -689 1 2 0 -3.958754 -1.022674 -2.555738 -690 1 4 0 -2.365328 -2.709721 -3.991308 -691 1 4 0 -2.556390 -4.179643 -2.968211 -692 1 4 0 -4.305604 -2.923554 -1.464240 -693 1 4 0 -2.062550 -3.144793 -0.620117 -694 1 4 0 -2.115031 -1.291482 -0.497561 -695 1 4 0 -1.342308 -2.211899 -1.862143 -696 1 4 0 -3.107951 -0.478453 -3.033604 -697 1 4 0 -4.161562 -0.403495 -1.628661 -698 1 4 0 -4.885892 -1.120725 -3.194404 -699 1 1 0 -3.856496 -3.700788 -6.722801 -700 1 2 0 -3.452842 -4.182763 -8.089520 -701 1 2 0 -2.174020 -3.372729 -8.520048 -702 1 3 0 -2.088562 -2.114569 -8.327579 -703 1 4 0 -3.898301 -2.618583 -6.734908 -704 1 4 0 -3.183017 -5.236597 -7.998616 -705 1 2 0 -4.717190 -3.967990 -8.947270 -706 1 2 0 -5.895436 -4.854833 -8.519342 -707 1 2 0 -4.331848 -4.232926 -10.428080 -708 1 2 0 -5.797633 -6.318004 -8.660393 -709 1 4 0 -4.967766 -2.891891 -8.863808 -710 1 4 0 -6.807800 -4.540991 -9.113471 -711 1 4 0 -6.224024 -4.682991 -7.474756 -712 1 4 0 -5.263890 -4.453041 -11.073519 -713 1 4 0 -3.637199 -5.120375 -10.524428 -714 1 4 0 -3.762608 -3.358380 -10.861528 -715 1 4 0 -4.807288 -6.678730 -8.216144 -716 1 4 0 -5.855482 -6.587729 -9.747066 -717 1 4 0 -6.665159 -6.845883 -8.176671 -718 1 1 0 -1.222564 -4.057751 -9.205087 -719 1 2 0 -0.136624 -3.415950 -9.921138 -720 1 2 0 0.070256 -3.976880 -11.394080 -721 1 3 0 0.610536 -5.076439 -11.582664 -722 1 4 0 -1.285072 -5.056820 -9.232195 -723 1 4 0 -0.492377 -2.326993 -10.196345 -724 1 2 0 1.325233 -3.451838 -9.292553 -725 1 2 0 2.252979 -2.485580 -9.980048 -726 1 2 0 1.821424 -1.150642 -9.963953 -727 1 2 0 3.553048 -2.772749 -10.524243 -728 1 2 0 2.627188 -0.136222 -10.473998 -729 1 2 0 4.271695 -1.747890 -11.019280 -730 1 2 0 3.875296 -0.391840 -11.048201 -731 1 4 0 1.721374 -4.514315 -9.302918 -732 1 4 0 1.363608 -3.152679 -8.161531 -733 1 4 0 0.900203 -0.869990 -9.442890 -734 1 4 0 4.058655 -3.780788 -10.525233 -735 1 4 0 2.406689 0.963664 -10.402987 -736 1 4 0 5.227337 -2.093738 -11.483853 -737 1 4 0 4.613135 0.382875 -11.414402 -738 1 1 0 -0.469213 -3.209862 -12.373989 -739 1 2 0 -0.546701 -3.542255 -13.816781 -740 1 2 0 -1.166423 -4.938647 -14.104553 -741 1 3 0 -0.706356 -5.741630 -14.896149 -742 1 4 0 -0.983659 -2.328002 -12.034153 -743 1 4 0 -1.328286 -2.810564 -14.197792 -744 1 2 0 0.847710 -3.453814 -14.522754 -745 1 4 0 1.557524 -2.617362 -14.253614 -746 1 4 0 0.737328 -3.373371 -15.641978 -747 1 4 0 1.440476 -4.334496 -14.238884 -748 1 1 0 -2.318816 -5.128826 -13.446057 -749 1 2 0 -3.143886 -6.311856 -13.378529 -750 1 2 0 -2.861305 -7.249269 -12.148953 -751 1 3 0 -3.693124 -8.018797 -11.770725 -752 1 4 0 -2.759876 -4.364139 -12.830293 -753 1 4 0 -4.238045 -6.105454 -13.271863 -754 1 4 0 -3.058170 -6.943948 -14.307195 -755 1 1 0 -1.585886 -7.303614 -11.606121 -756 1 2 0 -1.141926 -8.330961 -10.575659 -757 1 2 0 -1.714720 -8.146916 -9.185538 -758 1 3 0 -1.663641 -7.016934 -8.671236 -759 1 4 0 -0.991604 -6.486688 -11.627949 -760 1 4 0 -1.432507 -9.342075 -10.930403 -761 1 2 0 0.441949 -8.242663 -10.513047 -762 1 2 0 1.115895 -8.804397 -11.798957 -763 1 2 0 2.659392 -8.559556 -11.862927 -764 1 2 0 3.525297 -9.477008 -11.044076 -765 1 1 0 4.928913 -9.126450 -11.049928 -766 1 4 0 0.930008 -8.793558 -9.704840 -767 1 4 0 0.820281 -7.154573 -10.383627 -768 1 4 0 0.726808 -8.346899 -12.740661 -769 1 4 0 0.816642 -9.905594 -11.898832 -770 1 4 0 2.766554 -7.492314 -11.630235 -771 1 4 0 2.990272 -8.709413 -12.938787 -772 1 4 0 3.480243 -10.547229 -11.281436 -773 1 4 0 3.142144 -9.394311 -9.993141 -774 1 4 0 5.380243 -9.145878 -11.941964 -775 1 4 0 5.445854 -9.749951 -10.436478 -776 1 4 0 5.117208 -8.202842 -10.744769 -777 1 1 0 -2.261410 -9.249088 -8.588259 -778 1 2 0 -2.615396 -9.233499 -7.225533 -779 1 2 0 -1.335567 -8.948793 -6.438233 -780 1 3 0 -0.279868 -9.480653 -6.690356 -781 1 4 0 -2.255352 -10.169786 -9.074177 -782 1 4 0 -3.334713 -8.420685 -7.023961 -783 1 2 0 -3.251131 -10.563774 -6.767452 -784 1 2 0 -4.535149 -10.474262 -6.008036 -785 1 2 0 -4.398618 -9.939824 -4.513090 -786 1 3 0 -5.077126 -8.969050 -4.171499 -787 1 1 0 -3.545204 -10.582628 -3.678241 -788 1 4 0 -2.536808 -11.208918 -6.196239 -789 1 4 0 -3.428126 -11.121298 -7.678818 -790 1 4 0 -4.970296 -11.490264 -5.897297 -791 1 4 0 -5.221487 -9.801148 -6.555491 -792 1 4 0 -3.257694 -11.568395 -3.807768 -793 1 4 0 -3.345020 -10.122941 -2.746863 -794 1 1 0 -1.450039 -8.014788 -5.496898 -795 1 2 0 -0.421843 -7.645217 -4.599782 -796 1 2 0 -0.664467 -8.314648 -3.266854 -797 1 3 0 -1.615751 -8.129338 -2.521866 -798 1 4 0 -2.373522 -7.541372 -5.361698 -799 1 4 0 0.525104 -7.914594 -5.012102 -800 1 2 0 -0.361457 -6.082978 -4.502645 -801 1 2 0 0.013954 -5.455430 -5.851982 -802 1 2 0 0.049019 -3.957376 -5.617040 -803 1 2 0 1.428022 -5.979157 -6.227374 -804 1 4 0 0.435555 -5.929917 -3.703749 -805 1 4 0 -1.370222 -5.613724 -4.112042 -806 1 4 0 -0.783872 -5.696630 -6.601592 -807 1 4 0 -0.918682 -3.670337 -5.057847 -808 1 4 0 -0.051016 -3.481788 -6.645675 -809 1 4 0 0.927863 -3.578685 -5.148034 -810 1 4 0 1.304895 -7.011135 -6.510945 -811 1 4 0 2.256941 -6.075607 -5.425529 -812 1 4 0 1.836340 -5.473788 -7.076509 -813 1 1 0 0.008587 -9.534155 -3.176981 -814 1 2 0 -0.164006 -10.610017 -2.276861 -815 1 2 0 0.455793 -10.123372 -0.937523 -816 1 3 0 1.609433 -9.732719 -0.855349 -817 1 4 0 0.661532 -9.822276 -3.993714 -818 1 4 0 -1.244755 -10.767542 -2.035039 -819 1 2 0 0.574437 -11.905679 -2.866050 -820 1 2 0 0.334302 -13.196441 -2.052243 -821 1 2 0 0.695999 -13.209957 -0.547494 -822 1 3 0 -0.264686 -13.183024 0.298109 -823 1 3 0 1.910632 -13.459361 -0.183932 -824 1 4 0 1.710862 -11.775851 -2.827976 -825 1 4 0 0.358791 -11.917380 -3.993445 -826 1 4 0 0.882365 -13.997962 -2.620937 -827 1 4 0 -0.759904 -13.530227 -2.138213 -828 1 1 0 -0.357453 -10.118381 0.156881 -829 1 2 0 -0.126858 -9.579761 1.459753 -830 1 2 0 1.210865 -9.885856 2.201894 -831 1 3 0 1.578355 -9.098965 3.087348 -832 1 4 0 -1.314386 -10.278297 -0.048400 -833 1 4 0 -0.027285 -8.417312 1.375403 -834 1 2 0 -1.323443 -9.874534 2.428279 -835 1 2 0 -2.796658 -9.594191 2.040205 -836 1 3 0 -3.598938 -8.858694 2.747148 -837 1 3 0 -3.069275 -9.875155 0.835441 -838 1 4 0 -1.081085 -9.350501 3.331576 -839 1 4 0 -1.329114 -10.904878 2.757681 -840 1 1 0 1.774130 -11.086092 1.992881 -841 1 2 0 2.994120 -11.545091 2.708587 -842 1 2 0 4.377665 -11.351494 1.943197 -843 1 3 0 5.433148 -11.274449 2.624196 -844 1 4 0 1.231410 -11.794245 1.490134 -845 1 4 0 3.087086 -10.934376 3.717487 -846 1 4 0 2.994182 -12.632411 2.994368 -847 1 1 0 4.334836 -11.180015 0.643592 -848 1 2 0 5.298784 -10.617673 -0.256284 -849 1 2 0 5.545436 -9.161422 0.121481 -850 1 3 0 4.681756 -8.523001 0.675460 -851 1 4 0 3.389098 -11.194600 0.224796 -852 1 4 0 6.302556 -11.051188 -0.027697 -853 1 2 0 4.842303 -10.729803 -1.752153 -854 1 2 0 4.713323 -12.135756 -2.446341 -855 1 2 0 5.630639 -13.213151 -1.906582 -856 1 1 0 5.284941 -13.736409 -0.601898 -857 1 2 0 6.075566 -13.904284 0.492928 -858 1 1 0 7.378324 -13.682239 0.392183 -859 1 1 0 5.537046 -14.223213 1.666359 -860 1 4 0 5.533031 -10.123030 -2.400529 -861 1 4 0 3.921522 -10.207566 -1.834451 -862 1 4 0 4.892154 -12.013932 -3.582693 -863 1 4 0 3.646766 -12.426728 -2.380513 -864 1 4 0 6.696275 -12.970967 -1.977244 -865 1 4 0 5.489916 -14.113101 -2.629388 -866 1 4 0 4.272537 -13.863270 -0.494816 -867 1 4 0 7.985377 -13.700052 -0.424821 -868 1 4 0 7.940470 -13.667672 1.245648 -869 1 4 0 4.531855 -14.502228 1.787659 -870 1 4 0 6.101298 -14.389973 2.557369 -871 1 1 0 6.795959 -8.709417 -0.229618 -872 1 2 0 7.151484 -7.314826 -0.044504 -873 1 2 0 6.772152 -6.618863 -1.344791 -874 1 3 0 6.491580 -7.195037 -2.353138 -875 1 4 0 7.318576 -9.171415 -1.002843 -876 1 4 0 6.525833 -6.859535 0.829338 -877 1 2 0 8.635451 -7.121669 0.159249 -878 1 3 0 9.319110 -7.714935 -0.864105 -879 1 2 0 9.122393 -7.761915 1.542275 -880 1 4 0 8.861381 -6.006942 0.177513 -881 1 4 0 10.194312 -7.422946 -0.650194 -882 1 4 0 10.121810 -7.432113 1.729501 -883 1 4 0 9.135396 -8.869565 1.459149 -884 1 4 0 8.446951 -7.382073 2.362364 -885 1 1 0 6.963090 -5.264591 -1.254451 -886 1 2 0 6.942143 -4.382454 -2.396821 -887 1 2 0 8.032255 -4.727919 -3.355290 -888 1 3 0 7.874094 -4.700903 -4.606280 -889 1 4 0 7.090170 -4.902090 -0.328807 -890 1 4 0 6.016462 -4.502766 -2.986232 -891 1 2 0 7.011823 -2.893701 -1.884788 -892 1 2 0 5.619258 -2.371640 -1.146601 -893 1 2 0 5.747407 -0.832171 -0.836537 -894 1 2 0 4.304852 -2.632042 -1.932473 -895 1 4 0 7.232530 -2.302129 -2.742395 -896 1 4 0 7.918264 -2.789406 -1.123344 -897 1 4 0 5.453202 -2.916654 -0.186086 -898 1 4 0 4.887008 -0.456110 -0.323416 -899 1 4 0 5.896335 -0.152245 -1.791542 -900 1 4 0 6.670665 -0.673450 -0.254409 -901 1 4 0 4.181643 -2.082693 -2.916672 -902 1 4 0 3.442444 -2.383879 -1.330292 -903 1 4 0 4.282395 -3.716052 -2.117091 -904 1 1 0 9.237825 -5.055680 -2.844670 -905 1 2 0 10.327506 -5.326158 -3.751795 -906 1 2 0 10.299712 -6.687552 -4.448700 -907 1 3 0 11.020799 -6.802866 -5.444496 -908 1 4 0 9.513335 -4.765910 -1.839355 -909 1 4 0 10.385954 -4.560168 -4.527939 -910 1 2 0 11.616785 -5.225390 -2.849555 -911 1 3 0 11.681845 -6.184576 -1.811464 -912 1 4 0 11.731770 -4.245308 -2.404822 -913 1 4 0 12.479811 -5.484003 -3.480128 -914 1 4 0 12.247855 -6.858858 -2.142458 -915 1 1 0 9.390895 -7.583629 -4.036730 -916 1 2 0 8.992160 -8.754252 -4.825764 -917 1 2 0 8.441950 -8.325775 -6.179531 -918 1 3 0 8.453951 -9.076338 -7.106677 -919 1 4 0 8.901001 -7.489208 -3.091813 -920 1 4 0 10.003891 -9.220020 -5.018515 -921 1 2 0 8.053488 -9.759256 -4.183158 -922 1 2 0 8.636121 -10.682406 -3.119472 -923 1 3 0 8.285666 -10.472382 -1.922177 -924 1 3 0 9.461725 -11.579888 -3.491527 -925 1 4 0 7.570077 -10.438277 -4.930342 -926 1 4 0 7.245571 -9.201184 -3.714526 -927 1 1 0 7.768214 -7.119718 -6.199610 -928 1 2 0 7.005887 -6.638728 -7.315257 -929 1 2 0 7.851617 -5.582566 -8.113333 -930 1 3 0 7.595614 -5.232955 -9.268020 -931 1 4 0 7.640444 -6.594365 -5.349903 -932 1 4 0 6.951423 -7.445998 -8.104085 -933 1 2 0 5.604718 -6.020286 -6.971603 -934 1 2 0 4.808080 -7.258931 -6.484822 -935 1 2 0 4.589395 -7.461018 -5.120438 -936 1 2 0 4.447069 -8.273894 -7.429155 -937 1 2 0 3.784056 -8.535024 -4.755017 -938 1 2 0 3.579283 -9.310814 -7.055696 -939 1 2 0 3.326057 -9.397762 -5.690539 -940 1 3 0 2.439893 -10.287138 -5.195207 -941 1 4 0 5.141919 -5.567564 -7.921399 -942 1 4 0 5.606057 -5.151689 -6.311062 -943 1 4 0 4.944905 -6.731723 -4.350204 -944 1 4 0 4.660459 -8.167346 -8.489786 -945 1 4 0 3.457378 -8.750277 -3.665145 -946 1 4 0 3.267954 -10.081994 -7.761989 -947 1 4 0 2.186803 -10.747811 -5.996630 -948 1 1 0 8.902051 -5.011864 -7.407302 -949 1 2 0 9.703612 -3.896573 -7.971331 -950 1 2 0 8.854605 -2.738907 -8.339936 -951 1 3 0 9.065146 -2.145748 -9.384005 -952 1 4 0 9.116746 -5.266463 -6.458188 -953 1 4 0 10.386108 -3.586461 -7.092001 -954 1 2 0 10.578732 -4.353776 -9.179322 -955 1 2 0 11.689249 -3.400850 -9.487746 -956 1 3 0 11.683048 -2.729553 -10.505813 -957 1 1 0 12.685159 -3.379988 -8.534891 -958 1 4 0 9.859055 -4.483921 -10.059621 -959 1 4 0 11.053015 -5.363302 -8.978055 -960 1 4 0 12.816952 -4.073113 -7.744033 -961 1 4 0 13.500082 -2.669172 -8.653591 -962 1 1 0 7.961974 -2.346899 -7.450123 -963 1 2 0 7.210073 -1.082393 -7.353242 -964 1 2 0 8.220074 -0.014005 -6.989916 -965 1 3 0 8.976625 -0.122583 -6.038982 -966 1 4 0 7.839428 -2.859206 -6.569147 -967 1 4 0 6.707337 -0.850947 -8.383918 -968 1 2 0 6.030095 -1.285349 -6.242570 -969 1 2 0 4.899744 -1.930604 -7.085273 -970 1 2 0 5.645671 -0.002619 -5.492558 -971 1 2 0 3.850643 -2.639039 -6.295674 -972 1 4 0 6.419510 -1.908236 -5.417144 -973 1 4 0 5.364352 -2.708104 -7.784017 -974 1 4 0 4.483419 -1.167649 -7.800574 -975 1 4 0 5.004870 -0.066649 -4.602552 -976 1 4 0 5.129294 0.689353 -6.215366 -977 1 4 0 6.560668 0.460605 -5.074466 -978 1 4 0 3.234235 -1.930388 -5.649940 -979 1 4 0 4.384891 -3.374819 -5.577049 -980 1 4 0 3.162458 -3.233503 -6.928627 -981 1 1 0 8.279015 1.096767 -7.735473 -982 1 2 0 9.149500 2.177313 -7.448918 -983 1 2 0 8.443049 3.455173 -7.091881 -984 1 3 0 7.225838 3.588535 -7.314849 -985 1 4 0 7.643874 1.078344 -8.517521 -986 1 4 0 9.726155 1.989811 -6.530547 -987 1 2 0 10.141562 2.393897 -8.637297 -988 1 2 0 11.175363 1.278751 -8.856450 -989 1 2 0 12.297979 1.259017 -7.866598 -990 1 3 0 13.426383 1.600621 -8.288936 -991 1 1 0 12.128586 0.499484 -6.748544 -992 1 4 0 10.711669 3.336580 -8.503837 -993 1 4 0 9.628679 2.543322 -9.607849 -994 1 4 0 11.602578 1.390889 -9.880921 -995 1 4 0 10.646349 0.304077 -8.758295 -996 1 4 0 11.162328 0.324257 -6.474357 -997 1 4 0 12.859952 0.645961 -6.011600 -998 1 1 0 9.290608 4.442003 -6.647564 -999 1 2 0 8.811159 5.826111 -6.212163 -1000 1 2 0 7.909587 6.365352 -7.395189 -1001 1 3 0 8.277887 6.147537 -8.576688 -1002 1 4 0 10.326040 4.354253 -6.566650 -1003 1 4 0 8.074366 5.700259 -5.392561 -1004 1 2 0 9.995835 6.763127 -5.753453 -1005 1 2 0 11.134989 6.936166 -6.773871 -1006 1 2 0 12.450245 7.429690 -6.051861 -1007 1 2 0 12.385757 8.858415 -5.565813 -1008 1 1 0 13.633988 9.413177 -5.138817 -1009 1 4 0 10.292905 6.307034 -4.826845 -1010 1 4 0 9.733735 7.849575 -5.494064 -1011 1 4 0 10.808074 7.681538 -7.552779 -1012 1 4 0 11.297990 5.963599 -7.337475 -1013 1 4 0 13.159036 7.413697 -6.874982 -1014 1 4 0 12.808296 6.686485 -5.298299 -1015 1 4 0 11.641999 8.947159 -4.656213 -1016 1 4 0 11.959207 9.504307 -6.407475 -1017 1 4 0 13.653846 10.372301 -4.854541 -1018 1 4 0 14.288544 9.333898 -5.904378 -1019 1 4 0 14.092755 8.836443 -4.392426 -1020 1 1 0 6.734291 6.959000 -7.083862 -1021 1 2 0 5.689140 7.483124 -7.928906 -1022 1 2 0 4.722565 6.430009 -8.546693 -1023 1 3 0 3.693452 6.803359 -9.036911 -1024 1 4 0 6.540297 7.080673 -6.102459 -1025 1 4 0 4.958282 8.082892 -7.282649 -1026 1 2 0 6.303009 8.338869 -9.147185 -1027 1 2 0 6.962321 9.683020 -8.698706 -1028 1 2 0 6.113335 10.806050 -8.094806 -1029 1 3 0 5.314957 11.441914 -8.867803 -1030 1 3 0 6.281814 11.153556 -6.860003 -1031 1 4 0 5.501095 8.608142 -9.829181 -1032 1 4 0 7.017775 7.642829 -9.688511 -1033 1 4 0 7.483003 10.111296 -9.587458 -1034 1 4 0 7.840208 9.443341 -8.067185 -1035 1 1 0 4.989573 5.171451 -8.501981 -1036 1 2 0 4.030569 4.128878 -8.960795 -1037 1 2 0 2.659803 4.362057 -8.317970 -1038 1 3 0 2.633685 4.624499 -7.137127 -1039 1 4 0 5.932873 4.885550 -8.132184 -1040 1 4 0 3.970653 4.088976 -10.125056 -1041 1 2 0 4.547974 2.736928 -8.477716 -1042 1 3 0 5.739602 2.385810 -9.103937 -1043 1 4 0 3.830289 1.946588 -8.750291 -1044 1 4 0 4.757904 2.775726 -7.322086 -1045 1 4 0 6.399052 2.573026 -8.460448 -1046 1 1 0 1.554928 4.204648 -9.116288 -1047 1 2 0 0.143907 4.283937 -8.678656 -1048 1 2 0 -0.303717 2.830944 -8.588594 -1049 1 3 0 -0.192844 2.048979 -9.526722 -1050 1 4 0 1.755361 3.846256 -10.076285 -1051 1 4 0 0.145346 4.729291 -7.623107 -1052 1 2 0 -0.896382 4.990465 -9.602777 -1053 1 3 0 -0.546909 6.390258 -9.553197 -1054 1 2 0 -2.266687 5.014292 -9.040912 -1055 1 4 0 -0.839484 4.664962 -10.623152 -1056 1 4 0 -1.191403 6.852676 -10.030026 -1057 1 4 0 -2.370256 5.547925 -8.077780 -1058 1 4 0 -2.643323 3.985031 -8.945267 -1059 1 4 0 -3.015295 5.554521 -9.684458 -1060 1 1 0 -0.809824 2.397412 -7.387791 -1061 1 2 0 -1.543539 1.146508 -7.125034 -1062 1 2 0 -2.990030 1.446385 -7.471646 -1063 1 3 0 -3.473985 2.523645 -7.085299 -1064 1 4 0 -0.918513 3.078458 -6.559929 -1065 1 4 0 -1.082428 0.391021 -7.805730 -1066 1 2 0 -1.383109 0.737389 -5.704209 -1067 1 2 0 0.156980 0.778637 -5.025094 -1068 1 2 0 0.184063 0.045177 -3.655495 -1069 1 2 0 1.197637 0.213126 -5.986021 -1070 1 4 0 -1.814061 -0.254567 -5.578464 -1071 1 4 0 -2.073414 1.403223 -5.171331 -1072 1 4 0 0.570353 1.840354 -4.807618 -1073 1 4 0 -0.614353 0.329349 -2.926832 -1074 1 4 0 1.166261 0.241414 -3.114555 -1075 1 4 0 0.023700 -1.069031 -3.783533 -1076 1 4 0 2.158203 0.044818 -5.470973 -1077 1 4 0 1.222442 1.006598 -6.769381 -1078 1 4 0 0.965216 -0.653562 -6.606231 -1079 1 1 0 -3.781136 0.498160 -8.148625 -1080 1 2 0 -5.195999 0.627079 -8.395144 -1081 1 2 0 -5.839586 -0.173798 -7.325540 -1082 1 3 0 -5.682825 -1.396726 -7.207748 -1083 1 4 0 -3.423672 -0.475658 -8.058410 -1084 1 4 0 -5.466443 1.726348 -8.275345 -1085 1 2 0 -5.700075 0.093076 -9.698941 -1086 1 2 0 -5.439579 1.075796 -10.855403 -1087 1 1 0 -6.279526 2.029710 -11.458307 -1088 1 2 0 -4.192293 1.220658 -11.582303 -1089 1 2 0 -5.690995 2.592928 -12.533727 -1090 1 1 0 -4.422291 2.142927 -12.597346 -1091 1 4 0 -6.836699 -0.066381 -9.723009 -1092 1 4 0 -5.265040 -0.930234 -9.855749 -1093 1 4 0 -7.252692 2.264574 -11.108175 -1094 1 4 0 -3.349838 0.582035 -11.517840 -1095 1 4 0 -6.306793 3.255586 -13.155877 -1096 1 4 0 -3.777635 2.395819 -13.330102 -1097 1 1 0 -6.626714 0.438016 -6.407006 -1098 1 2 0 -7.321255 -0.209395 -5.260830 -1099 1 2 0 -8.726044 -0.540624 -5.779334 -1100 1 3 0 -9.643748 0.246853 -6.020516 -1101 1 4 0 -6.861887 1.458160 -6.506142 -1102 1 4 0 -6.783811 -1.126314 -4.931556 -1103 1 2 0 -7.394204 0.687745 -4.053531 -1104 1 2 0 -8.296909 0.064749 -2.869849 -1105 1 2 0 -7.951698 -1.454279 -2.487926 -1106 1 2 0 -8.060038 0.927044 -1.568059 -1107 1 4 0 -7.854595 1.761490 -4.347062 -1108 1 4 0 -6.360197 0.997945 -3.694450 -1109 1 4 0 -9.450918 0.148422 -3.062584 -1110 1 4 0 -7.020548 -1.637465 -1.993488 -1111 1 4 0 -7.993278 -2.155479 -3.352501 -1112 1 4 0 -8.718116 -1.826418 -1.776705 -1113 1 4 0 -6.906806 1.040935 -1.329769 -1114 1 4 0 -8.507678 0.388091 -0.676703 -1115 1 4 0 -8.513627 1.951825 -1.684662 -1116 1 1 0 -8.874500 -1.873711 -5.910632 -1117 1 2 0 -10.054693 -2.628336 -6.198564 -1118 1 2 0 -10.572111 -3.015072 -4.753004 -1119 1 3 0 -9.832635 -3.443205 -3.816546 -1120 1 4 0 -7.996568 -2.422971 -5.836674 -1121 1 4 0 -10.870694 -1.994424 -6.483439 -1122 1 2 0 -9.759279 -3.959835 -7.069730 -1123 1 2 0 -10.946970 -4.877626 -7.068986 -1124 1 2 0 -9.371460 -3.542046 -8.470112 -1125 1 4 0 -8.949402 -4.516022 -6.543614 -1126 1 4 0 -11.541359 -4.965020 -6.098983 -1127 1 4 0 -10.625500 -5.914327 -7.249472 -1128 1 4 0 -11.748695 -4.562709 -7.779917 -1129 1 4 0 -8.371018 -3.050033 -8.468892 -1130 1 4 0 -10.059019 -2.758287 -8.851634 -1131 1 4 0 -9.340042 -4.349447 -9.290806 -1132 1 1 0 -11.926250 -3.006119 -4.579854 -1133 1 2 0 -12.599868 -3.427499 -3.271795 -1134 1 2 0 -13.119425 -4.819080 -3.443024 -1135 1 3 0 -13.506292 -5.208366 -4.502651 -1136 1 4 0 -12.484786 -2.940272 -5.402807 -1137 1 4 0 -11.809544 -3.497303 -2.534649 -1138 1 2 0 -13.689712 -2.401148 -2.755481 -1139 1 2 0 -13.005610 -1.020901 -2.289793 -1140 1 2 0 -13.886801 0.170603 -2.491323 -1141 1 2 0 -12.530133 -1.092500 -0.802600 -1142 1 4 0 -14.252193 -2.898736 -1.884096 -1143 1 4 0 -14.401815 -2.226641 -3.620690 -1144 1 4 0 -12.072590 -0.884860 -2.820312 -1145 1 4 0 -13.445227 1.217778 -2.222189 -1146 1 4 0 -14.793098 0.063548 -1.909740 -1147 1 4 0 -14.187182 0.152067 -3.578149 -1148 1 4 0 -13.308581 -1.365227 -0.079185 -1149 1 4 0 -12.103016 -0.144811 -0.412295 -1150 1 4 0 -11.612023 -1.776214 -0.714294 -1151 1 1 0 -13.156998 -5.622978 -2.323616 -1152 1 2 0 -13.787861 -6.967978 -2.285282 -1153 1 2 0 -15.146212 -6.800506 -1.593340 -1154 1 3 0 -15.158053 -6.442067 -0.396674 -1155 1 4 0 -12.804286 -5.282526 -1.428142 -1156 1 4 0 -13.916618 -7.485164 -3.412935 -1157 1 2 0 -12.946414 -7.979280 -1.497063 -1158 1 2 0 -13.667631 -9.245528 -0.905442 -1159 1 2 0 -12.815857 -10.499980 -0.801429 -1160 1 1 0 -11.666913 -10.382988 0.124040 -1161 1 2 0 -10.598009 -11.176366 0.312631 -1162 1 1 0 -10.307009 -12.288930 -0.364431 -1163 1 1 0 -9.633279 -10.774307 1.106366 -1164 1 4 0 -12.386465 -7.607216 -0.581206 -1165 1 4 0 -12.215820 -8.370972 -2.244713 -1166 1 4 0 -14.479446 -9.568262 -1.529164 -1167 1 4 0 -14.129833 -9.168539 0.056180 -1168 1 4 0 -12.412465 -10.669174 -1.854364 -1169 1 4 0 -13.466079 -11.423733 -0.479836 -1170 1 4 0 -11.512692 -9.382182 0.495625 -1171 1 4 0 -10.805304 -12.650925 -1.216224 -1172 1 4 0 -9.470321 -12.815770 -0.049797 -1173 1 4 0 -9.791948 -9.915404 1.677222 -1174 1 4 0 -8.883682 -11.348748 1.394071 -1175 1 1 0 -16.257217 -7.220554 -2.308703 -1176 1 2 0 -17.613518 -7.141694 -1.748926 -1177 1 2 0 -17.781416 -8.219845 -0.663951 -1178 1 3 0 -17.284390 -9.348310 -0.956865 -1179 1 4 0 -16.199694 -7.696122 -3.255195 -1180 1 4 0 -17.779696 -6.166353 -1.252915 -1181 1 2 0 -18.748459 -7.363962 -2.843069 -1182 1 2 0 -18.849202 -6.260828 -3.989572 -1183 1 2 0 -19.614490 -6.870808 -5.148395 -1184 1 2 0 -19.500680 -4.982113 -3.494742 -1185 1 4 0 -19.731301 -7.397251 -2.283025 -1186 1 4 0 -18.632820 -8.422553 -3.243609 -1187 1 4 0 -17.781339 -6.071752 -4.343559 -1188 1 4 0 -19.542258 -6.264447 -6.144731 -1189 1 4 0 -20.684366 -6.894552 -4.987517 -1190 1 4 0 -19.302207 -7.942787 -5.285929 -1191 1 4 0 -19.636746 -4.174795 -4.365113 -1192 1 4 0 -18.901688 -4.545004 -2.684455 -1193 1 4 0 -20.591982 -5.186371 -3.176857 -1194 1 1 0 -18.472240 -7.923944 0.433190 -1195 1 2 0 -18.558377 -8.661913 1.684016 -1196 1 2 0 -19.865592 -8.197617 2.423657 -1197 1 3 0 -20.225574 -7.007408 2.517047 -1198 1 4 0 -19.018633 -7.045923 0.383040 -1199 1 4 0 -18.591712 -9.815151 1.449892 -1200 1 2 0 -17.330534 -8.352242 2.590189 -1201 1 2 0 -17.197501 -9.255175 3.894695 -1202 1 2 0 -15.917138 -8.993799 4.761448 -1203 1 1 0 -15.862754 -7.604311 5.340549 -1204 1 2 0 -14.953946 -7.213621 6.222257 -1205 1 1 0 -13.939504 -7.925565 6.768523 -1206 1 1 0 -15.231901 -6.019110 6.758979 -1207 1 4 0 -17.334188 -7.257380 2.696147 -1208 1 4 0 -16.422266 -8.568012 1.978366 -1209 1 4 0 -17.281791 -10.298139 3.520877 -1210 1 4 0 -18.121600 -9.053051 4.460330 -1211 1 4 0 -14.891329 -9.193895 4.266694 -1212 1 4 0 -16.028045 -9.747706 5.563074 -1213 1 4 0 -16.694442 -6.992689 5.266552 -1214 1 4 0 -13.473108 -8.806088 6.384760 -1215 1 4 0 -13.382022 -7.560903 7.513773 -1216 1 4 0 -16.061939 -5.573954 6.401806 -1217 1 4 0 -14.719788 -5.491070 7.406533 -1218 1 1 0 -20.555642 -9.238644 2.984101 -1219 1 2 0 -21.702627 -8.980829 3.816986 -1220 1 2 0 -22.667592 -10.144922 3.908536 -1221 1 3 0 -23.356911 -10.299018 4.988328 -1222 1 4 0 -20.172384 -10.204330 3.007070 -1223 1 4 0 -21.390921 -8.619000 4.839945 -1224 1 4 0 -22.324153 -8.174944 3.384408 -1225 1 1 0 -22.722375 -11.026698 2.860636 -1226 1 2 0 -23.459566 -12.247827 2.845542 -1227 1 2 0 -22.978621 -13.438108 1.985225 -1228 1 3 0 -23.756241 -13.995796 1.178096 -1229 1 4 0 -22.154953 -11.003456 1.998676 -1230 1 4 0 -23.492303 -12.585024 3.945342 -1231 1 4 0 -24.562029 -11.982169 2.632418 -1232 1 3 0 -21.741623 -13.731454 2.030156 -1233 2 6 0 -25.305889 -8.873286 2.603094 -1234 2 4 0 -26.195231 -8.788006 2.967312 -1235 2 4 0 -25.362163 -9.790033 2.275871 -1236 3 6 0 1.912477 -17.151817 -13.840126 -1237 3 4 0 1.018390 -17.464992 -13.630219 -1238 3 4 0 2.439262 -17.334772 -13.036215 -1239 4 6 0 8.975970 -6.483371 7.068342 -1240 4 4 0 8.251083 -5.855922 6.942323 -1241 4 4 0 9.786320 -5.989537 6.904165 -1242 5 6 0 -17.059429 -6.682892 -18.382532 -1243 5 4 0 -17.356881 -6.533480 -19.279335 -1244 5 4 0 -16.147993 -6.804945 -18.480643 -1245 6 6 0 11.369980 -7.303894 20.323145 -1246 6 4 0 10.458255 -7.203431 20.535809 -1247 6 4 0 11.777545 -7.941380 20.905100 -1248 7 6 0 3.047993 13.115234 13.513593 -1249 7 4 0 2.189597 12.815932 13.781761 -1250 7 4 0 3.351020 13.772449 14.197587 -1251 8 6 0 9.177488 -19.531354 -17.025005 -1252 8 4 0 8.997180 -19.923922 -17.884170 -1253 8 4 0 8.309703 -19.391487 -16.606802 -1254 9 6 0 -23.848340 -5.791211 7.441678 -1255 9 4 0 -24.004055 -6.746691 7.261738 -1256 9 4 0 -23.114081 -5.501409 6.867622 -1257 10 6 0 20.312209 0.171955 -11.773561 -1258 10 4 0 20.146745 1.095650 -12.020368 -1259 10 4 0 21.238842 0.205679 -11.456820 -1260 11 6 0 -22.314798 3.014770 5.149047 -1261 11 4 0 -22.929289 2.276522 4.980524 -1262 11 4 0 -22.201264 3.090196 6.138941 -1263 12 6 0 26.239381 8.286972 11.597675 -1264 12 4 0 26.254621 7.398022 11.997034 -1265 12 4 0 26.842192 8.820608 12.190091 -1266 13 6 0 1.081563 20.255845 0.892389 -1267 13 4 0 0.921065 19.278377 0.845371 -1268 13 4 0 1.812904 20.277503 0.290341 -1269 14 6 0 -25.838005 -18.994104 1.429638 -1270 14 4 0 -26.326160 -18.188143 1.703932 -1271 14 4 0 -25.342908 -19.303427 2.200872 -1272 15 6 0 -20.846054 -7.092652 6.478370 -1273 15 4 0 -20.166552 -7.554414 6.018306 -1274 15 4 0 -21.115422 -7.596368 7.225200 -1275 16 6 0 25.160173 -4.728893 -15.381523 -1276 16 4 0 24.661069 -4.062502 -14.979503 -1277 16 4 0 25.990165 -4.238213 -15.567710 -1278 17 6 0 14.535913 -19.677013 15.675709 -1279 17 4 0 14.037278 -20.588075 15.600840 -1280 17 4 0 14.211502 -19.181601 14.912412 -1281 18 6 0 2.857645 5.855417 4.079262 -1282 18 4 0 3.430506 5.710138 4.830199 -1283 18 4 0 2.475458 6.741420 4.276791 -1284 19 6 0 -27.372739 -15.194690 -19.205198 -1285 19 4 0 -28.210581 -15.653921 -19.162899 -1286 19 4 0 -27.456185 -14.667250 -19.960242 -1287 20 6 0 17.781541 0.602750 -19.513277 -1288 20 4 0 17.110642 0.664367 -18.792643 -1289 20 4 0 18.099117 1.530660 -19.555262 -1290 21 6 0 8.088032 9.439765 10.567445 -1291 21 4 0 8.015346 10.287070 10.169518 -1292 21 4 0 8.124832 9.462611 11.569641 -1293 22 6 0 15.345860 8.714934 -11.152067 -1294 22 4 0 15.658920 9.075500 -11.972725 -1295 22 4 0 14.523818 9.211910 -11.028938 -1296 23 6 0 11.013253 17.283874 -4.348263 -1297 23 4 0 10.789838 18.205570 -4.504969 -1298 23 4 0 10.260676 16.779106 -4.055437 -1299 24 6 0 -12.889592 -16.760154 20.387880 -1300 24 4 0 -13.380671 -16.152118 19.799845 -1301 24 4 0 -13.369275 -16.639729 21.191087 -1302 25 6 0 25.866516 4.706708 -8.061449 -1303 25 4 0 25.769362 4.461317 -8.965208 -1304 25 4 0 25.764828 5.656105 -8.114825 -1305 26 6 0 -26.248807 10.809987 -17.556369 -1306 26 4 0 -25.862537 10.639607 -16.669023 -1307 26 4 0 -25.586772 10.275331 -18.075376 -1308 27 6 0 5.011891 -0.095276 11.102149 -1309 27 4 0 5.950070 -0.328570 10.928116 -1310 27 4 0 4.658035 -0.692033 11.838618 -1311 28 6 0 -3.238023 12.776925 -11.754925 -1312 28 4 0 -3.559468 13.177496 -12.562608 -1313 28 4 0 -2.242036 12.949361 -11.730152 -1314 29 6 0 7.608155 6.209090 6.533228 -1315 29 4 0 6.751309 6.368791 6.939913 -1316 29 4 0 7.470608 5.288476 6.273733 -1317 30 6 0 14.666135 -14.922987 -11.755230 -1318 30 4 0 14.581988 -14.800079 -10.784928 -1319 30 4 0 15.226569 -14.207434 -12.104465 -1320 31 6 0 15.326386 3.732831 -20.745668 -1321 31 4 0 14.863781 4.277641 -20.063559 -1322 31 4 0 14.723700 3.157686 -21.298124 -1323 32 6 0 18.627348 -11.469990 6.467592 -1324 32 4 0 19.047503 -12.239416 6.986935 -1325 32 4 0 19.345653 -10.823603 6.332871 -1326 33 6 0 -14.220347 1.309533 12.809953 -1327 33 4 0 -15.112916 1.674865 12.966390 -1328 33 4 0 -13.905824 1.691626 11.972749 -1329 34 6 0 17.738294 20.743473 -0.318702 -1330 34 4 0 16.798924 21.074482 -0.373811 -1331 34 4 0 18.299449 21.160545 -1.000515 -1332 35 6 0 20.455752 2.132791 12.340284 -1333 35 4 0 19.810773 1.395571 12.257305 -1334 35 4 0 20.198026 2.647549 11.503824 -1335 36 6 0 9.853022 -4.726683 18.073966 -1336 36 4 0 9.922207 -4.319154 18.942345 -1337 36 4 0 10.745493 -4.795112 17.634995 -1338 37 6 0 22.828162 7.406766 18.911442 -1339 37 4 0 23.277041 7.740752 18.085874 -1340 37 4 0 21.875678 7.287001 18.697167 -1341 38 6 0 12.857348 6.858682 -2.850558 -1342 38 4 0 12.349544 7.638411 -2.700800 -1343 38 4 0 13.434641 6.773930 -2.100368 -1344 39 6 0 10.156535 2.406121 -18.658294 -1345 39 4 0 10.409878 1.989225 -19.465922 -1346 39 4 0 9.490048 3.103188 -18.852928 -1347 40 6 0 12.554233 20.216080 19.570476 -1348 40 4 0 11.705682 19.810667 19.782475 -1349 40 4 0 12.468266 20.347772 18.588160 -1350 41 6 0 -1.134276 6.357754 18.934733 -1351 41 4 0 -1.973226 6.075942 19.245633 -1352 41 4 0 -0.442075 6.043387 19.552910 -1353 42 6 0 1.750577 4.009032 13.244051 -1354 42 4 0 1.218838 4.545834 13.791599 -1355 42 4 0 1.398756 3.100724 13.349288 -1356 43 6 0 2.689021 16.465513 4.587974 -1357 43 4 0 3.467483 16.279752 5.178457 -1358 43 4 0 3.010897 17.110882 3.971315 -1359 44 6 0 22.627367 7.401815 -6.857148 -1360 44 4 0 21.892213 7.078953 -7.539727 -1361 44 4 0 22.599466 6.767179 -6.162623 -1362 45 6 0 -24.350411 -14.025041 19.899958 -1363 45 4 0 -23.879390 -13.314568 19.375377 -1364 45 4 0 -25.008554 -14.400223 19.294992 -1365 46 6 0 18.357304 9.543924 6.204099 -1366 46 4 0 18.326985 9.093740 5.378574 -1367 46 4 0 19.117744 9.183856 6.709862 -1368 47 6 0 21.017970 -11.520615 -11.071883 -1369 47 4 0 21.726613 -10.894899 -10.978046 -1370 47 4 0 20.726915 -11.629983 -10.116083 -1371 48 6 0 -26.667012 4.365972 15.083664 -1372 48 4 0 -27.091443 3.550925 15.267577 -1373 48 4 0 -25.989136 4.193758 14.444620 -1374 49 6 0 12.781386 0.642540 16.526237 -1375 49 4 0 13.038723 1.476289 17.006927 -1376 49 4 0 12.089659 0.933072 15.871227 -1377 50 6 0 -27.429715 -6.725581 8.240721 -1378 50 4 0 -26.910936 -6.564480 7.470893 -1379 50 4 0 -28.162464 -7.327953 7.969065 -1380 51 6 0 24.070362 5.174514 -0.911512 -1381 51 4 0 24.629840 5.966148 -0.705486 -1382 51 4 0 23.362520 5.287238 -1.509298 -1383 52 6 0 16.846666 -16.995462 -13.603864 -1384 52 4 0 15.867560 -16.748669 -13.456021 -1385 52 4 0 17.071846 -16.254095 -14.246763 -1386 53 6 0 20.841116 12.797120 17.009497 -1387 53 4 0 20.969187 13.669803 17.421731 -1388 53 4 0 21.771225 12.416689 16.764510 -1389 54 6 0 -19.221734 -18.875573 -10.983743 -1390 54 4 0 -20.186979 -18.779925 -10.982038 -1391 54 4 0 -19.009681 -19.369621 -10.158798 -1392 55 6 0 -18.683521 -20.505972 -16.031221 -1393 55 4 0 -19.618898 -20.618800 -16.082058 -1394 55 4 0 -18.315789 -21.292104 -15.650396 -1395 56 6 0 13.486524 6.749112 5.293446 -1396 56 4 0 13.961609 6.056192 4.983058 -1397 56 4 0 12.780504 7.007906 4.716738 -1398 57 6 0 20.810382 20.409198 13.765268 -1399 57 4 0 21.268029 20.454532 14.598864 -1400 57 4 0 19.895912 20.318361 13.998352 -1401 58 6 0 20.363727 -12.785030 1.387420 -1402 58 4 0 20.625728 -12.042183 1.970150 -1403 58 4 0 19.472843 -13.114509 1.692870 -1404 59 6 0 -4.110768 13.121183 -4.644500 -1405 59 4 0 -3.600734 12.558925 -4.032909 -1406 59 4 0 -4.403120 13.867412 -4.044378 -1407 60 6 0 -21.061840 -7.740629 20.493954 -1408 60 4 0 -21.039453 -7.543946 19.536841 -1409 60 4 0 -21.757349 -7.146898 20.900973 -1410 61 6 0 26.211082 -13.851944 -14.351632 -1411 61 4 0 26.688652 -13.578058 -13.560156 -1412 61 4 0 25.237610 -13.844318 -14.168406 -1413 62 6 0 7.682001 -20.605822 4.285305 -1414 62 4 0 8.364066 -21.007718 3.810153 -1415 62 4 0 7.192709 -19.999465 3.748655 -1416 63 6 0 22.004930 15.161537 5.915259 -1417 63 4 0 22.529069 15.401145 5.140758 -1418 63 4 0 21.836857 14.241604 6.044353 -1419 64 6 0 21.713613 -17.900383 3.815703 -1420 64 4 0 22.679247 -17.725384 3.950726 -1421 64 4 0 21.695664 -18.649618 3.180406 -1422 65 6 0 11.567159 -18.128823 12.553393 -1423 65 4 0 11.856655 -17.178344 12.428270 -1424 65 4 0 11.248307 -18.230630 13.449380 -1425 66 6 0 -22.622068 18.057993 -12.095565 -1426 66 4 0 -21.694228 17.853670 -11.941877 -1427 66 4 0 -22.819172 17.835208 -12.993248 -1428 67 6 0 9.275007 12.390062 -11.584253 -1429 67 4 0 8.977379 13.016934 -10.914605 -1430 67 4 0 10.127813 12.041771 -11.232361 -1431 68 6 0 -14.822916 -15.989738 9.135198 -1432 68 4 0 -14.194812 -16.628214 9.459309 -1433 68 4 0 -14.342626 -15.188459 9.014917 -1434 69 6 0 -11.828358 -9.561319 -4.583271 -1435 69 4 0 -12.150096 -9.065398 -5.351378 -1436 69 4 0 -12.516681 -10.185548 -4.230080 -1437 70 6 0 -10.898855 6.281982 -10.651011 -1438 70 4 0 -11.533704 6.844824 -10.249357 -1439 70 4 0 -10.394778 5.928734 -9.945580 -1440 71 6 0 10.206251 18.878731 19.697794 -1441 71 4 0 10.128033 18.397864 20.526746 -1442 71 4 0 9.368907 19.321892 19.635002 -1443 72 6 0 7.056097 15.592239 15.029949 -1444 72 4 0 7.186116 15.478315 14.072096 -1445 72 4 0 7.414569 14.832987 15.435389 -1446 73 6 0 24.543977 3.489901 -14.044452 -1447 73 4 0 23.682275 3.287251 -13.651175 -1448 73 4 0 24.372867 3.165473 -14.930902 -1449 74 6 0 -0.579079 -10.101283 9.711937 -1450 74 4 0 -1.148742 -10.353328 9.005933 -1451 74 4 0 -0.914837 -9.213566 9.976954 -1452 75 6 0 6.810722 17.081705 -5.703105 -1453 75 4 0 5.903603 16.716054 -5.813888 -1454 75 4 0 7.038830 17.199405 -6.631357 -1455 76 6 0 -26.352729 7.462163 20.420411 -1456 76 4 0 -27.199047 7.711650 20.831378 -1457 76 4 0 -26.411228 7.671245 19.444854 -1458 77 6 0 17.042652 1.713603 8.364686 -1459 77 4 0 16.951087 0.795520 8.175385 -1460 77 4 0 16.736372 2.035025 7.509624 -1461 78 6 0 19.131873 19.334012 -6.335242 -1462 78 4 0 18.416265 18.729295 -6.454050 -1463 78 4 0 19.910836 18.805924 -6.078777 -1464 79 6 0 7.310440 -10.543485 13.587642 -1465 79 4 0 6.863481 -11.404338 13.838041 -1466 79 4 0 6.716557 -9.980934 13.023023 -1467 80 6 0 16.655451 5.245734 12.848556 -1468 80 4 0 17.418946 5.791006 12.911180 -1469 80 4 0 16.851104 4.455072 13.419371 -1470 81 6 0 -11.098331 12.748199 -7.329972 -1471 81 4 0 -11.009338 13.599863 -7.754046 -1472 81 4 0 -12.065844 12.538087 -7.393876 -1473 82 6 0 -12.334041 -5.457784 -13.381783 -1474 82 4 0 -12.711013 -4.568395 -13.257780 -1475 82 4 0 -11.461517 -5.234972 -13.709702 -1476 83 6 0 -19.619563 15.046747 6.026220 -1477 83 4 0 -19.064160 15.888434 5.869584 -1478 83 4 0 -20.197675 14.948767 5.270745 -1479 84 6 0 19.403362 5.853957 6.190263 -1480 84 4 0 18.497327 6.115780 6.469846 -1481 84 4 0 20.017752 6.471645 6.487352 -1482 85 6 0 -25.726372 -3.750023 6.981390 -1483 85 4 0 -26.510590 -3.855351 7.566875 -1484 85 4 0 -25.108784 -4.364237 7.293376 -1485 86 6 0 19.363936 -15.722056 8.477199 -1486 86 4 0 19.376520 -16.156352 9.371325 -1487 86 4 0 20.131991 -16.106093 8.026790 -1488 87 6 0 4.918015 16.654603 6.129016 -1489 87 4 0 5.581517 17.300026 5.845056 -1490 87 4 0 5.390842 15.802197 6.094486 -1491 88 6 0 6.078733 16.693115 -13.842069 -1492 88 4 0 5.199251 16.442614 -14.064650 -1493 88 4 0 6.443869 16.763088 -14.767416 -1494 89 6 0 21.731326 -12.551581 -19.815904 -1495 89 4 0 21.519077 -11.572592 -19.819800 -1496 89 4 0 21.264568 -12.901316 -18.987186 -1497 90 6 0 24.487045 0.545827 12.845924 -1498 90 4 0 24.038085 0.883409 12.081688 -1499 90 4 0 24.083597 0.980384 13.591108 -1500 91 6 0 18.410889 -13.655540 -1.593840 -1501 91 4 0 18.336634 -14.202424 -0.852695 -1502 91 4 0 19.187521 -13.942267 -2.059694 -1503 92 6 0 10.380738 17.460434 -20.015294 -1504 92 4 0 9.800569 16.677901 -20.098710 -1505 92 4 0 10.044263 17.935616 -19.257888 -1506 93 6 0 13.540400 13.359091 -2.277273 -1507 93 4 0 13.918768 14.199197 -2.621352 -1508 93 4 0 13.546416 13.374894 -1.268707 -1509 94 6 0 19.550822 -15.885302 -17.171256 -1510 94 4 0 19.618925 -16.577230 -17.813037 -1511 94 4 0 20.364869 -15.924821 -16.745913 -1512 95 6 0 8.934453 -16.027660 20.082161 -1513 95 4 0 8.350825 -15.432721 20.504320 -1514 95 4 0 9.504005 -15.407057 19.696244 -1515 96 6 0 13.449317 -0.696209 -11.399773 -1516 96 4 0 14.259684 -0.816041 -10.861718 -1517 96 4 0 12.841649 -1.407477 -11.030433 -1518 97 6 0 21.159598 -20.230615 11.116255 -1519 97 4 0 20.955379 -21.039069 10.677683 -1520 97 4 0 21.227629 -20.467861 12.046012 -1521 98 6 0 -11.425719 10.313603 15.561621 -1522 98 4 0 -11.752060 9.489612 15.149018 -1523 98 4 0 -12.009787 11.024201 15.339594 -1524 99 6 0 23.530234 5.073332 12.308815 -1525 99 4 0 23.411228 4.192303 12.037314 -1526 99 4 0 23.017800 5.539035 11.565588 -1527 100 6 0 9.285394 15.401019 4.247587 -1528 100 4 0 9.029223 16.111512 4.827382 -1529 100 4 0 9.908946 14.931813 4.786975 -1530 101 6 0 26.710953 10.879732 17.565984 -1531 101 4 0 26.481837 11.014223 18.458503 -1532 101 4 0 26.801930 11.751805 17.193691 -1533 102 6 0 26.059219 -18.322514 -8.230640 -1534 102 4 0 25.468209 -17.831491 -8.807599 -1535 102 4 0 26.660395 -17.588693 -7.832128 -1536 103 6 0 7.573847 10.494945 -13.000340 -1537 103 4 0 6.752773 10.585941 -12.508913 -1538 103 4 0 8.060915 11.203548 -12.596091 -1539 104 6 0 16.495334 16.907261 -17.264088 -1540 104 4 0 15.936311 17.701142 -17.215765 -1541 104 4 0 16.146725 16.404479 -17.972530 -1542 105 6 0 12.550501 12.792681 0.441559 -1543 105 4 0 12.890193 12.783948 1.424080 -1544 105 4 0 12.972043 11.976735 0.117581 -1545 106 6 0 6.804544 2.469256 9.043785 -1546 106 4 0 7.053760 2.925055 9.856512 -1547 106 4 0 7.365554 1.678918 9.065958 -1548 107 6 0 -26.111190 11.845380 12.004953 -1549 107 4 0 -26.772515 12.430684 11.621087 -1550 107 4 0 -25.209540 12.292191 11.872070 -1551 108 6 0 -10.314383 -9.317643 -12.200930 -1552 108 4 0 -11.268643 -8.984584 -12.345854 -1553 108 4 0 -10.432002 -10.035760 -11.529786 -1554 109 6 0 -26.380108 15.118882 -9.622008 -1555 109 4 0 -25.930871 15.887042 -9.924512 -1556 109 4 0 -25.979073 14.306361 -10.084998 -1557 110 6 0 1.139515 -19.714505 -8.279716 -1558 110 4 0 0.675447 -19.100241 -8.876686 -1559 110 4 0 1.861101 -19.991496 -8.757935 -1560 111 6 0 17.452914 16.822171 9.920464 -1561 111 4 0 17.934078 17.151660 9.199989 -1562 111 4 0 17.980199 16.103548 10.329451 -1563 112 6 0 18.740004 -12.107924 14.391777 -1564 112 4 0 19.596584 -12.274465 14.867937 -1565 112 4 0 18.902733 -12.244474 13.491103 -1566 113 6 0 -15.579375 6.511760 13.017065 -1567 113 4 0 -15.193219 7.321701 12.610540 -1568 113 4 0 -15.093538 5.769586 12.622079 -1569 114 6 0 -0.877815 -3.636485 14.316002 -1570 114 4 0 -1.480812 -3.188883 14.944590 -1571 114 4 0 -1.224311 -3.235271 13.526942 -1572 115 6 0 7.516564 -9.888221 20.928138 -1573 115 4 0 7.083616 -9.984725 20.119275 -1574 115 4 0 7.035439 -10.492537 21.460270 -1575 116 6 0 26.972175 15.513650 13.835965 -1576 116 4 0 27.290530 14.677325 14.220401 -1577 116 4 0 26.022826 15.628989 13.956832 -1578 117 6 0 18.373056 16.436866 -9.784173 -1579 117 4 0 18.173740 16.705423 -10.702898 -1580 117 4 0 19.003590 17.095921 -9.494087 -1581 118 6 0 -2.499599 -10.235115 -18.681799 -1582 118 4 0 -2.484635 -9.679910 -17.855014 -1583 118 4 0 -1.762196 -9.952193 -19.147621 -1584 119 6 0 2.170631 9.696760 -13.707491 -1585 119 4 0 2.410831 10.573952 -14.022044 -1586 119 4 0 1.366528 9.911718 -13.203660 -1587 120 6 0 -22.060495 0.084333 -19.330968 -1588 120 4 0 -21.759145 -0.801023 -19.628154 -1589 120 4 0 -21.345397 0.598803 -18.978005 -1590 121 6 0 20.717073 -0.364667 -3.266977 -1591 121 4 0 20.064258 -0.869174 -2.840894 -1592 121 4 0 20.978768 -0.863225 -4.123117 -1593 122 6 0 -11.693545 -17.585832 12.155919 -1594 122 4 0 -11.693581 -16.618165 12.297539 -1595 122 4 0 -10.965597 -17.630843 11.482629 -1596 123 6 0 22.033287 -5.610818 11.814279 -1597 123 4 0 21.603774 -4.969289 11.213082 -1598 123 4 0 22.863855 -5.854126 11.399621 -1599 124 6 0 -4.245364 20.530679 -11.580108 -1600 124 4 0 -4.613077 20.058542 -10.812152 -1601 124 4 0 -4.869612 21.297733 -11.750599 -1602 125 6 0 20.837886 3.849343 18.187160 -1603 125 4 0 21.637221 4.154388 17.767478 -1604 125 4 0 20.753725 4.316852 19.044680 -1605 126 6 0 4.000998 20.642070 6.993614 -1606 126 4 0 3.097228 20.600441 6.539412 -1607 126 4 0 4.007858 20.203528 7.895914 -1608 127 6 0 11.947977 15.441293 -0.469120 -1609 127 4 0 11.971275 14.454085 -0.273912 -1610 127 4 0 12.470807 15.488877 -1.291943 -1611 128 6 0 3.007637 18.543541 -2.984774 -1612 128 4 0 3.565232 17.725540 -3.038270 -1613 128 4 0 2.929337 18.913789 -3.837866 -1614 129 6 0 8.597796 -3.024177 11.307241 -1615 129 4 0 9.440361 -2.907621 10.794269 -1616 129 4 0 8.194484 -3.777321 10.948431 -1617 130 6 0 12.969092 -7.932168 -3.416690 -1618 130 4 0 12.657272 -8.671538 -3.962914 -1619 130 4 0 13.930699 -7.927015 -3.644128 -1620 131 6 0 4.690692 11.990242 6.047085 -1621 131 4 0 3.830915 11.620745 5.794047 -1622 131 4 0 5.366958 11.770788 5.369987 -1623 132 6 0 10.838100 15.915400 -16.690449 -1624 132 4 0 11.719066 16.216650 -16.583824 -1625 132 4 0 10.351788 16.668150 -17.062399 -1626 133 6 0 20.760419 3.237669 6.554876 -1627 133 4 0 20.210628 2.565167 6.189576 -1628 133 4 0 20.243367 4.047032 6.450547 -1629 134 6 0 -7.351853 -2.751166 -10.694739 -1630 134 4 0 -8.277520 -2.829710 -11.023595 -1631 134 4 0 -6.973902 -2.027001 -11.286243 -1632 135 6 0 8.338680 -14.152925 -14.216839 -1633 135 4 0 7.907963 -14.913791 -13.766433 -1634 135 4 0 9.057618 -14.554948 -14.672432 -1635 136 6 0 -21.745003 -1.600080 -8.484704 -1636 136 4 0 -22.396276 -0.906185 -8.690601 -1637 136 4 0 -21.042086 -1.417961 -9.157366 -1638 137 6 0 24.505779 -7.277316 -14.651231 -1639 137 4 0 24.835649 -6.369110 -14.893362 -1640 137 4 0 24.135101 -7.595011 -15.516575 -1641 138 6 0 13.325591 -5.149951 -6.169737 -1642 138 4 0 14.291969 -5.289577 -6.041288 -1643 138 4 0 12.813376 -5.844865 -5.785812 -1644 139 6 0 -20.933242 20.161591 -8.696079 -1645 139 4 0 -20.088965 20.396502 -9.157616 -1646 139 4 0 -21.417399 20.940524 -8.320759 -1647 140 6 0 22.832947 -8.348413 -10.288572 -1648 140 4 0 23.575495 -7.724229 -10.313126 -1649 140 4 0 23.029160 -9.044226 -9.677546 -1650 141 6 0 23.743445 2.427859 19.849750 -1651 141 4 0 24.532045 1.907225 19.711678 -1652 141 4 0 23.062926 1.994077 19.368217 -1653 142 6 0 10.589993 1.639740 20.516878 -1654 142 4 0 9.987052 1.032362 20.047348 -1655 142 4 0 10.624644 2.472330 20.027640 -1656 143 6 0 6.500815 -17.047237 7.812429 -1657 143 4 0 7.407059 -16.956263 7.440866 -1658 143 4 0 6.013508 -17.774059 7.384568 -1659 144 6 0 -0.199269 -9.380208 -16.449921 -1660 144 4 0 -0.920685 -8.715985 -16.515053 -1661 144 4 0 0.387469 -9.304809 -17.255371 -1662 145 6 0 6.245654 20.180381 -12.940075 -1663 145 4 0 5.376160 20.220616 -13.392701 -1664 145 4 0 6.857081 19.702851 -13.499407 -1665 146 6 0 -4.928957 -20.301289 11.340442 -1666 146 4 0 -4.017513 -20.158995 11.049259 -1667 146 4 0 -4.923799 -20.953195 11.990322 -1668 147 6 0 -11.515851 -8.388468 19.647979 -1669 147 4 0 -11.184791 -8.359618 20.524675 -1670 147 4 0 -12.443923 -8.327763 19.606292 -1671 148 6 0 -24.167509 7.194575 -0.837148 -1672 148 4 0 -24.972654 7.649920 -1.275517 -1673 148 4 0 -24.204709 7.474688 0.131591 -1674 149 6 0 12.126351 -16.062203 11.096539 -1675 149 4 0 11.280449 -15.927172 10.574646 -1676 149 4 0 12.611089 -15.288570 10.879908 -1677 150 6 0 -7.169287 5.827131 17.736258 -1678 150 4 0 -6.956548 5.152949 17.035326 -1679 150 4 0 -6.291387 6.127541 18.098754 -1680 151 6 0 -19.820265 12.907447 16.581358 -1681 151 4 0 -19.659011 12.980070 17.534136 -1682 151 4 0 -20.478433 13.648938 16.483830 -1683 152 6 0 10.474631 10.634400 -7.924386 -1684 152 4 0 10.794363 11.386619 -7.409132 -1685 152 4 0 9.591861 10.377005 -7.560987 -1686 153 6 0 9.869765 7.468088 9.667232 -1687 153 4 0 9.072542 8.000794 9.695304 -1688 153 4 0 10.102662 7.299293 8.720054 -1689 154 6 0 11.149756 9.562904 -12.765396 -1690 154 4 0 10.686250 9.267978 -11.959062 -1691 154 4 0 11.324858 8.766817 -13.298380 -1692 155 6 0 -8.591767 12.757143 -4.012695 -1693 155 4 0 -8.324896 13.003317 -4.932948 -1694 155 4 0 -8.147829 13.384049 -3.416515 -1695 156 6 0 4.774504 19.024876 15.999665 -1696 156 4 0 4.160294 19.017277 16.757162 -1697 156 4 0 5.517925 18.569472 16.400595 -1698 157 6 0 -4.714429 -2.091345 19.353537 -1699 157 4 0 -4.854280 -2.828837 19.971329 -1700 157 4 0 -5.535288 -2.163222 18.793806 -1701 158 6 0 3.570216 -18.611817 -15.598378 -1702 158 4 0 3.046765 -18.582990 -16.425866 -1703 158 4 0 3.158896 -17.918154 -15.032600 -1704 159 6 0 -11.657691 18.235653 20.509864 -1705 159 4 0 -12.226759 18.986315 20.717707 -1706 159 4 0 -11.080397 18.121952 21.271087 -1707 160 6 0 14.493937 -0.382813 19.719393 -1708 160 4 0 13.979118 -0.142020 20.470391 -1709 160 4 0 15.349953 -0.432678 20.118874 -1710 161 6 0 -25.714868 -12.047610 -14.994953 -1711 161 4 0 -25.527994 -12.236118 -16.000515 -1712 161 4 0 -24.876261 -11.553460 -14.748410 -1713 162 6 0 6.325847 -15.764455 11.544131 -1714 162 4 0 6.229128 -16.154079 12.417251 -1715 162 4 0 6.886521 -15.002890 11.743125 -1716 163 6 0 -27.331883 9.233246 15.237568 -1717 163 4 0 -26.599380 9.867873 14.994627 -1718 163 4 0 -27.264332 8.495991 14.623286 -1719 164 6 0 -25.207375 -3.847132 17.095096 -1720 164 4 0 -25.445321 -4.629286 16.543803 -1721 164 4 0 -25.823438 -3.158780 16.776808 -1722 165 6 0 -2.766266 -13.179260 4.266317 -1723 165 4 0 -1.896026 -13.215786 3.757612 -1724 165 4 0 -3.151612 -14.038152 4.175240 -1725 166 6 0 17.165111 16.676060 6.100929 -1726 166 4 0 17.064451 17.522432 6.606579 -1727 166 4 0 16.942925 15.940574 6.655125 -1728 167 6 0 -18.331646 7.552754 -8.484008 -1729 167 4 0 -18.933791 7.004225 -7.919061 -1730 167 4 0 -18.900890 7.785944 -9.196075 -1731 168 6 0 26.169311 3.132717 9.584634 -1732 168 4 0 26.518912 3.613350 10.302634 -1733 168 4 0 25.680453 2.435972 9.901377 -1734 169 6 0 1.192323 17.107553 -8.736586 -1735 169 4 0 1.021901 17.797734 -9.422544 -1736 169 4 0 0.892750 17.475660 -7.885822 -1737 170 6 0 -25.815030 10.180500 5.376868 -1738 170 4 0 -26.459337 10.344257 6.080597 -1739 170 4 0 -25.337134 9.352614 5.563562 -1740 171 6 0 9.219642 -20.775000 0.193729 -1741 171 4 0 9.939354 -21.194791 -0.335512 -1742 171 4 0 8.458200 -21.122557 -0.245347 -1743 172 6 0 7.419149 -15.012981 -7.052183 -1744 172 4 0 7.072086 -14.800593 -6.138570 -1745 172 4 0 6.878848 -15.717530 -7.366638 -1746 173 6 0 18.623745 10.156288 3.028217 -1747 173 4 0 17.982257 9.440233 2.875628 -1748 173 4 0 18.009023 10.975494 3.182536 -1749 174 6 0 13.145546 -20.676260 -16.694649 -1750 174 4 0 12.815312 -20.227755 -17.488442 -1751 174 4 0 12.786182 -21.555938 -16.737351 -1752 175 6 0 4.910310 -17.490236 -1.378014 -1753 175 4 0 5.657779 -17.456107 -0.820623 -1754 175 4 0 5.268563 -17.934730 -2.200934 -1755 176 6 0 -0.270185 6.286195 9.930733 -1756 176 4 0 -0.856415 6.001917 10.611025 -1757 176 4 0 0.005563 7.171058 10.176397 -1758 177 6 0 -3.229650 16.643646 19.387659 -1759 177 4 0 -3.312058 16.163949 18.538257 -1760 177 4 0 -2.782251 17.481594 19.257422 -1761 178 6 0 -16.368157 2.960013 13.098824 -1762 178 4 0 -16.360100 3.430962 13.984851 -1763 178 4 0 -16.773065 3.567928 12.508334 -1764 179 6 0 19.447080 -6.209321 9.611666 -1765 179 4 0 18.833539 -5.622887 9.193795 -1766 179 4 0 18.949525 -6.526265 10.384214 -1767 180 6 0 -8.044280 -4.288816 -16.207882 -1768 180 4 0 -7.966109 -3.883769 -17.074640 -1769 180 4 0 -7.261903 -4.793399 -15.982149 -1770 181 6 0 20.024947 17.270827 14.758218 -1771 181 4 0 19.172341 17.478642 15.170634 -1772 181 4 0 20.700921 17.006922 15.403538 -1773 182 6 0 24.735763 -12.617736 3.782055 -1774 182 4 0 24.742238 -13.518522 3.370896 -1775 182 4 0 25.350602 -12.232493 3.147824 -1776 183 6 0 3.431414 8.925671 6.826679 -1777 183 4 0 3.084862 8.827163 7.759644 -1778 183 4 0 4.424412 9.107829 6.895448 -1779 184 6 0 17.489102 -11.319977 19.702626 -1780 184 4 0 18.434347 -11.550903 19.419885 -1781 184 4 0 16.965653 -12.122535 19.583109 -1782 185 6 0 13.274816 16.183286 -2.849704 -1783 185 4 0 13.777976 16.949053 -2.573649 -1784 185 4 0 12.549844 16.546466 -3.345363 -1785 186 6 0 23.841910 -13.944818 11.597095 -1786 186 4 0 23.043336 -14.386099 11.958056 -1787 186 4 0 23.668687 -13.015455 11.845078 -1788 187 6 0 14.458157 -17.498951 -20.684884 -1789 187 4 0 13.916318 -16.687121 -20.523929 -1790 187 4 0 14.348004 -17.977683 -19.850686 -1791 188 6 0 -8.369104 15.140447 -19.622301 -1792 188 4 0 -9.156426 14.702367 -19.949175 -1793 188 4 0 -7.765440 15.416867 -20.299390 -1794 189 6 0 19.145293 -12.193056 11.874609 -1795 189 4 0 18.766654 -11.373734 11.579591 -1796 189 4 0 18.521350 -12.726230 11.327543 -1797 190 6 0 -18.076775 18.801612 -14.295021 -1798 190 4 0 -18.586562 18.486836 -15.063616 -1799 190 4 0 -18.385853 18.166574 -13.559441 -1800 191 6 0 -19.106085 17.513715 -16.406412 -1801 191 4 0 -18.423458 17.909352 -17.009956 -1802 191 4 0 -19.076533 16.547362 -16.469991 -1803 192 6 0 8.044684 -0.011875 -10.373353 -1804 192 4 0 8.668860 -0.626009 -9.915411 -1805 192 4 0 8.602268 0.704634 -10.757756 -1806 193 6 0 -23.287552 -7.074362 17.929889 -1807 193 4 0 -22.370365 -7.411352 17.793085 -1808 193 4 0 -23.082861 -6.243551 18.339191 -1809 194 6 0 22.099315 -0.856463 5.137385 -1810 194 4 0 22.143526 -1.231806 5.942781 -1811 194 4 0 22.809699 -1.264756 4.609180 -1812 195 6 0 11.618777 5.171830 -12.366225 -1813 195 4 0 12.078170 4.347700 -12.198463 -1814 195 4 0 10.837551 5.069580 -11.726531 -1815 196 6 0 13.014153 9.452672 -20.836207 -1816 196 4 0 13.647981 9.913017 -20.352836 -1817 196 4 0 13.495084 8.718233 -21.270254 -1818 197 6 0 12.425877 4.164162 0.171584 -1819 197 4 0 12.703840 3.756309 0.988868 -1820 197 4 0 12.991444 5.029213 0.073462 -1821 198 6 0 -9.835180 14.629378 -13.804396 -1822 198 4 0 -9.610077 14.944151 -14.684564 -1823 198 4 0 -8.989021 14.154277 -13.615953 -1824 199 6 0 -2.408060 19.252237 0.880939 -1825 199 4 0 -2.493340 19.315730 -0.074698 -1826 199 4 0 -2.255762 20.125803 1.185504 -1827 200 6 0 0.176360 18.576859 -11.340843 -1828 200 4 0 0.973470 18.653833 -11.875634 -1829 200 4 0 -0.251936 19.428753 -11.234458 -1830 201 6 0 17.647376 -13.725079 1.965824 -1831 201 4 0 17.003636 -13.021631 1.726278 -1832 201 4 0 17.566508 -13.822114 2.932054 -1833 202 6 0 22.517860 -11.753774 5.019726 -1834 202 4 0 23.053003 -11.763573 4.218425 -1835 202 4 0 22.141706 -12.627432 4.996598 -1836 203 6 0 11.399220 8.806142 17.642468 -1837 203 4 0 12.004399 8.181799 18.040253 -1838 203 4 0 12.065291 9.442856 17.324430 -1839 204 6 0 -22.707547 3.590100 -15.076457 -1840 204 4 0 -23.015628 3.384474 -15.944834 -1841 204 4 0 -22.136913 4.410365 -15.213029 -1842 205 6 0 26.828338 -4.765161 15.663973 -1843 205 4 0 26.832047 -4.257803 16.501858 -1844 205 4 0 26.708016 -5.703070 15.737740 -1845 206 6 0 22.946626 3.404021 -19.628978 -1846 206 4 0 23.362608 3.005393 -20.435220 -1847 206 4 0 23.702005 3.678843 -19.069388 -1848 207 6 0 14.618693 -13.688118 5.201099 -1849 207 4 0 14.145978 -13.778387 4.371412 -1850 207 4 0 14.286294 -12.904817 5.661369 -1851 208 6 0 20.255504 -4.724409 16.548573 -1852 208 4 0 21.059576 -4.438221 16.144026 -1853 208 4 0 20.147655 -4.094495 17.295647 -1854 209 6 0 17.946944 -13.347081 -18.020931 -1855 209 4 0 18.795624 -13.646112 -18.426334 -1856 209 4 0 17.332163 -14.081728 -18.189230 -1857 210 6 0 -21.344615 -17.675607 -16.681902 -1858 210 4 0 -21.267118 -18.651712 -16.747948 -1859 210 4 0 -21.006193 -17.563628 -15.786919 -1860 211 6 0 9.992481 17.630547 2.228887 -1861 211 4 0 10.766809 17.530717 1.634799 -1862 211 4 0 9.806200 16.754569 2.642189 -1863 212 6 0 24.337802 -5.112482 8.921340 -1864 212 4 0 24.079827 -4.328771 8.467115 -1865 212 4 0 24.773308 -4.851600 9.745303 -1866 213 6 0 14.392943 4.303039 -14.169804 -1867 213 4 0 15.354569 4.444986 -14.451391 -1868 213 4 0 13.827235 4.378323 -14.920116 -1869 214 6 0 13.209648 -16.451396 -6.580199 -1870 214 4 0 13.147603 -16.683269 -5.631990 -1871 214 4 0 12.554494 -16.916090 -7.141613 -1872 215 6 0 -11.258451 -8.728449 -17.504889 -1873 215 4 0 -10.630935 -8.841887 -16.742169 -1874 215 4 0 -10.880429 -7.995350 -17.987253 -1875 216 6 0 6.970091 -11.502288 7.137693 -1876 216 4 0 6.712825 -11.950891 7.959605 -1877 216 4 0 6.204207 -11.628119 6.619766 -1878 217 6 0 -10.553038 -2.495546 -20.126478 -1879 217 4 0 -11.112035 -2.806841 -20.861108 -1880 217 4 0 -10.112026 -1.746092 -20.545249 -1881 218 6 0 1.164804 16.447528 -16.932229 -1882 218 4 0 1.075245 17.028648 -17.728070 -1883 218 4 0 0.434843 16.567725 -16.272167 -1884 219 6 0 8.169876 -8.073942 10.663670 -1885 219 4 0 8.495588 -8.362155 9.831946 -1886 219 4 0 7.357988 -8.507192 10.922724 -1887 220 6 0 -9.618401 15.869865 -1.419048 -1888 220 4 0 -10.476694 15.771852 -1.849867 -1889 220 4 0 -9.747028 16.624761 -0.845144 -1890 221 6 0 -16.212359 4.292450 15.905633 -1891 221 4 0 -15.313397 4.006789 16.095169 -1892 221 4 0 -16.439629 4.732906 16.740073 -1893 222 6 0 21.084596 9.207592 -17.940912 -1894 222 4 0 20.944531 8.655711 -18.738875 -1895 222 4 0 20.567153 10.036337 -17.965821 -1896 223 6 0 6.469383 -5.770861 20.006921 -1897 223 4 0 5.993567 -6.597617 19.829705 -1898 223 4 0 7.305198 -6.017049 20.409842 -1899 224 6 0 17.758755 -18.446472 11.244435 -1900 224 4 0 16.943206 -18.055205 11.026410 -1901 224 4 0 17.620974 -18.589448 12.216673 -1902 225 6 0 2.239377 -2.639523 -18.372832 -1903 225 4 0 2.961435 -2.802836 -17.698014 -1904 225 4 0 2.575925 -2.857520 -19.307575 -1905 226 6 0 21.718884 10.313541 3.085849 -1906 226 4 0 21.842990 10.122072 2.194243 -1907 226 4 0 20.773441 10.408461 3.286860 -1908 227 6 0 13.337112 -4.261456 -15.095198 -1909 227 4 0 12.794211 -4.900007 -14.644470 -1910 227 4 0 14.199509 -4.728814 -15.315507 -1911 228 6 0 -9.310962 9.865254 8.826714 -1912 228 4 0 -9.669554 9.579689 7.984792 -1913 228 4 0 -9.735207 9.276237 9.445171 -1914 229 6 0 -15.178299 -9.566992 -12.324180 -1915 229 4 0 -15.367699 -10.462879 -12.630414 -1916 229 4 0 -14.646062 -9.588613 -11.528432 -1917 230 6 0 -15.859885 -9.750776 8.964734 -1918 230 4 0 -15.304809 -9.850444 8.125201 -1919 230 4 0 -16.789316 -9.705790 8.757985 -1920 231 6 0 -25.239908 11.310293 -1.569623 -1921 231 4 0 -25.920791 10.663431 -1.377427 -1922 231 4 0 -24.373594 10.784234 -1.594237 -1923 232 6 0 24.834518 19.880125 -12.068838 -1924 232 4 0 24.902598 19.037821 -11.641999 -1925 232 4 0 24.569359 20.529336 -11.363034 -1926 233 6 0 -4.910084 -12.441089 2.868321 -1927 233 4 0 -4.196304 -12.571833 3.512128 -1928 233 4 0 -4.472778 -12.489053 1.987214 -1929 234 6 0 26.315754 13.248691 -3.958358 -1930 234 4 0 27.266655 13.212107 -4.180929 -1931 234 4 0 26.465406 13.335958 -3.028348 -1932 235 6 0 24.328527 13.817013 16.149181 -1933 235 4 0 24.827781 14.030624 16.932358 -1934 235 4 0 24.179636 14.591188 15.603219 -1935 236 6 0 21.962373 -16.827624 8.004516 -1936 236 4 0 22.598048 -16.206072 7.580939 -1937 236 4 0 22.450590 -17.261823 8.740917 -1938 237 6 0 -4.825363 -16.614974 -12.877741 -1939 237 4 0 -4.014790 -16.722031 -13.388018 -1940 237 4 0 -4.509200 -15.980807 -12.256351 -1941 238 6 0 23.185997 6.818710 7.631707 -1942 238 4 0 24.005009 7.366044 7.817913 -1943 238 4 0 22.474898 7.499325 7.506791 -1944 239 6 0 6.937383 5.850956 20.832797 -1945 239 4 0 7.490164 6.651357 20.679338 -1946 239 4 0 6.435673 5.734889 20.013467 -1947 240 6 0 25.402656 -2.159701 -17.957744 -1948 240 4 0 25.621496 -3.084064 -17.880786 -1949 240 4 0 25.529344 -1.860574 -18.911595 -1950 241 6 0 10.846509 -11.228008 2.120758 -1951 241 4 0 9.913338 -11.028888 2.277705 -1952 241 4 0 11.049198 -10.691152 1.384887 -1953 242 6 0 23.084559 -1.383675 -1.852278 -1954 242 4 0 23.773226 -1.138388 -2.498419 -1955 242 4 0 22.268498 -0.905061 -2.136333 -1956 243 6 0 -25.783789 -13.543097 -4.342707 -1957 243 4 0 -26.780798 -13.463014 -4.533505 -1958 243 4 0 -25.653740 -14.383466 -3.955333 -1959 244 6 0 1.861632 12.171063 18.076482 -1960 244 4 0 2.556591 11.916600 18.652688 -1961 244 4 0 1.260792 12.537866 18.715290 -1962 245 6 0 -19.142537 14.105154 8.572032 -1963 245 4 0 -19.793181 13.415150 8.631452 -1964 245 4 0 -19.398536 14.384324 7.672644 -1965 246 6 0 9.479353 -2.096525 -4.320850 -1966 246 4 0 10.426570 -2.240688 -4.643403 -1967 246 4 0 9.264888 -1.350839 -4.888316 -1968 247 6 0 3.551422 -11.576062 19.271265 -1969 247 4 0 4.336383 -11.005500 19.220941 -1970 247 4 0 3.612389 -12.122719 20.093542 -1971 248 6 0 -18.654239 -9.535541 17.560019 -1972 248 4 0 -17.877715 -9.179943 17.854976 -1973 248 4 0 -18.494513 -10.119241 16.820922 -1974 249 6 0 22.066324 -17.399278 -0.499821 -1975 249 4 0 21.820234 -16.674838 0.099599 -1976 249 4 0 21.433067 -17.360481 -1.209273 -1977 250 6 0 -9.234082 15.614627 11.653381 -1978 250 4 0 -8.328429 15.947628 11.735875 -1979 250 4 0 -9.156328 14.657428 11.604942 -1980 251 6 0 22.367726 20.360775 16.024793 -1981 251 4 0 21.845316 20.438168 16.820627 -1982 251 4 0 23.011426 21.038841 16.155608 -1983 252 6 0 25.827187 -16.169219 18.903921 -1984 252 4 0 25.252638 -15.420311 18.639632 -1985 252 4 0 25.326971 -16.554629 19.621305 -1986 253 6 0 -19.668270 -7.707320 -8.620499 -1987 253 4 0 -19.491830 -6.794820 -8.636334 -1988 253 4 0 -20.495353 -7.784914 -8.110009 -1989 254 6 0 -15.712732 17.116061 17.387342 -1990 254 4 0 -14.998205 17.679818 17.573935 -1991 254 4 0 -16.301994 17.627283 16.828989 -1992 255 6 0 0.390078 14.938221 -20.122911 -1993 255 4 0 -0.551277 14.873494 -20.329275 -1994 255 4 0 0.539841 14.256395 -19.453229 -1995 256 6 0 15.977716 -18.683555 17.772786 -1996 256 4 0 15.456606 -18.921580 16.979089 -1997 256 4 0 16.280568 -17.751033 17.661557 -1998 257 6 0 5.239306 11.123091 17.557541 -1999 257 4 0 4.918202 10.242467 17.653834 -2000 257 4 0 6.086403 10.952070 18.021365 -2001 258 6 0 9.328850 -5.185156 13.272163 -2002 258 4 0 9.601653 -6.131901 13.229534 -2003 258 4 0 9.762360 -4.740121 12.531719 -2004 259 6 0 25.477790 -8.345165 0.584885 -2005 259 4 0 25.598427 -7.389198 0.879361 -2006 259 4 0 26.086040 -8.798249 1.118095 -2007 260 6 0 17.311830 -17.527015 -10.578123 -2008 260 4 0 17.719447 -16.732289 -10.965110 -2009 260 4 0 16.654082 -17.252150 -9.925765 -2010 261 6 0 -4.429164 -9.201790 -14.116626 -2011 261 4 0 -4.244658 -8.992311 -13.212737 -2012 261 4 0 -5.336375 -8.936542 -14.234036 -2013 262 6 0 2.267339 -4.673980 16.117302 -2014 262 4 0 3.232259 -4.591281 16.113612 -2015 262 4 0 1.900019 -4.413838 16.958419 -2016 263 6 0 25.781004 -8.714690 8.400591 -2017 263 4 0 24.912042 -8.751175 8.867313 -2018 263 4 0 25.752072 -9.508607 7.845086 -2019 264 6 0 24.780338 7.832712 -16.490027 -2020 264 4 0 25.553470 8.297242 -16.909830 -2021 264 4 0 24.349053 7.422109 -17.205903 -2022 265 6 0 -10.973211 -14.579748 -20.349565 -2023 265 4 0 -11.809581 -14.181319 -20.199526 -2024 265 4 0 -11.271798 -15.372634 -20.833354 -2025 266 6 0 20.831402 -9.834964 6.727716 -2026 266 4 0 21.613032 -10.442134 6.754402 -2027 266 4 0 20.647604 -9.731183 7.657599 -2028 267 6 0 0.619789 -15.810628 3.994148 -2029 267 4 0 0.887335 -16.417198 3.309856 -2030 267 4 0 1.249715 -15.910162 4.713083 -2031 268 6 0 23.689965 0.227417 -19.055575 -2032 268 4 0 23.390627 1.115135 -18.834814 -2033 268 4 0 24.618115 0.214091 -18.686279 -2034 269 6 0 -19.356143 -14.966182 6.464534 -2035 269 4 0 -18.731353 -14.875616 7.195912 -2036 269 4 0 -19.299498 -14.034705 6.108709 -2037 270 6 0 -4.810820 7.093213 18.692708 -2038 270 4 0 -4.214506 7.397678 17.991691 -2039 270 4 0 -5.304442 7.897279 18.897729 -2040 271 6 0 12.472494 14.825856 12.199392 -2041 271 4 0 11.666376 14.488038 12.655650 -2042 271 4 0 12.151762 15.361991 11.488854 -2043 272 6 0 -2.525590 -19.553036 -5.583420 -2044 272 4 0 -3.387077 -20.012041 -5.603558 -2045 272 4 0 -1.916602 -19.904101 -6.266561 -2046 273 6 0 -13.215935 11.484331 -2.785220 -2047 273 4 0 -12.887174 11.682417 -1.972234 -2048 273 4 0 -12.509591 11.786661 -3.422263 -2049 274 6 0 13.801640 -19.398163 -2.800474 -2050 274 4 0 12.819741 -19.619737 -2.646754 -2051 274 4 0 13.897982 -19.592042 -3.772199 -2052 275 6 0 -26.233001 19.527836 -20.067788 -2053 275 4 0 -25.451886 18.897692 -20.194468 -2054 275 4 0 -26.399315 19.934622 -20.917526 -2055 276 6 0 8.349896 -20.273103 -5.512912 -2056 276 4 0 8.674030 -19.375363 -5.549945 -2057 276 4 0 7.700037 -20.342277 -4.787842 -2058 277 6 0 -15.037355 -17.935516 15.211469 -2059 277 4 0 -14.146082 -18.339695 15.389947 -2060 277 4 0 -15.202223 -17.984699 14.215392 -2061 278 6 0 8.152699 -3.220333 -19.381684 -2062 278 4 0 7.762730 -2.473688 -19.830286 -2063 278 4 0 8.435795 -2.793242 -18.522747 -2064 279 6 0 10.849575 20.172811 -12.945894 -2065 279 4 0 9.989543 19.760584 -12.890237 -2066 279 4 0 10.974253 20.477018 -13.831243 -2067 280 6 0 -18.094216 -18.088456 -0.091619 -2068 280 4 0 -17.380813 -18.647373 0.106032 -2069 280 4 0 -18.936664 -18.511988 -0.052421 -2070 281 6 0 23.784383 -1.234714 -8.545459 -2071 281 4 0 23.004694 -0.954068 -8.088149 -2072 281 4 0 23.886388 -2.202962 -8.397824 -2073 282 6 0 4.670856 19.296845 -6.507264 -2074 282 4 0 5.525567 19.132893 -6.020467 -2075 282 4 0 4.474979 18.536310 -7.056492 -2076 283 6 0 9.453183 -16.128245 10.894262 -2077 283 4 0 9.172486 -17.052303 10.804233 -2078 283 4 0 8.694890 -15.636054 10.554101 -2079 284 6 0 27.285633 -19.419687 13.608447 -2080 284 4 0 27.147712 -20.155434 14.224268 -2081 284 4 0 27.432376 -19.841205 12.735609 -2082 285 6 0 -13.953143 18.767914 -18.628277 -2083 285 4 0 -14.509541 18.177509 -19.151919 -2084 285 4 0 -14.459773 19.481659 -18.276757 -2085 286 6 0 -8.503297 -13.558947 20.139036 -2086 286 4 0 -9.241112 -13.897460 20.705789 -2087 286 4 0 -7.777412 -13.533354 20.859006 -2088 287 6 0 14.842167 15.398345 -11.842827 -2089 287 4 0 14.711447 15.430309 -12.769279 -2090 287 4 0 14.422321 14.556870 -11.583006 -2091 288 6 0 23.515535 -17.148566 -6.707313 -2092 288 4 0 22.824916 -16.517939 -6.421660 -2093 288 4 0 24.263955 -17.052636 -6.082683 -2094 289 6 0 19.904467 -17.703379 -13.473161 -2095 289 4 0 20.119864 -16.820025 -13.921272 -2096 289 4 0 18.948028 -17.662123 -13.295016 -2097 290 6 0 -9.019729 7.630624 20.233912 -2098 290 4 0 -8.958585 7.872806 21.205680 -2099 290 4 0 -8.777610 8.395080 19.734355 -2100 291 6 0 -16.953402 12.468570 8.282984 -2101 291 4 0 -17.680339 13.160784 8.478943 -2102 291 4 0 -17.500933 11.923064 7.633961 -2103 292 6 0 -8.054795 18.180983 8.459840 -2104 292 4 0 -8.807469 17.559774 8.499933 -2105 292 4 0 -7.598916 17.959389 7.659706 -2106 293 6 0 10.859202 13.972660 9.371520 -2107 293 4 0 10.330904 14.662590 8.917941 -2108 293 4 0 11.760678 13.901317 8.995461 -2109 294 6 0 -20.599796 5.434907 14.082586 -2110 294 4 0 -19.823357 5.807091 13.669543 -2111 294 4 0 -20.650272 4.587948 13.614754 -2112 295 6 0 0.190160 0.223418 -18.957409 -2113 295 4 0 0.213080 -0.260216 -19.803123 -2114 295 4 0 -0.108015 1.088627 -19.162666 -2115 296 6 0 -14.055059 -11.353804 -4.019394 -2116 296 4 0 -14.940567 -11.063742 -3.674139 -2117 296 4 0 -13.870222 -12.125592 -3.430663 -2118 297 6 0 16.635849 17.308753 12.681784 -2119 297 4 0 16.261670 16.470264 12.423079 -2120 297 4 0 17.008841 17.677123 11.849363 -2121 298 6 0 -25.308969 5.432856 -17.149527 -2122 298 4 0 -24.655164 5.918154 -17.671798 -2123 298 4 0 -24.982451 5.555957 -16.246756 -2124 299 6 0 -5.099798 0.287541 -14.704188 -2125 299 4 0 -5.138931 0.519591 -15.635776 -2126 299 4 0 -4.195405 -0.084328 -14.624163 -2127 300 6 0 -23.748764 -10.173408 15.212702 -2128 300 4 0 -23.345980 -11.023651 15.356645 -2129 300 4 0 -22.994745 -9.539993 15.112815 -2130 301 6 0 -19.199669 -17.758897 16.946421 -2131 301 4 0 -19.316903 -16.926776 16.445483 -2132 301 4 0 -18.281115 -18.078783 16.752689 -2133 302 6 0 24.275104 4.639677 -5.172613 -2134 302 4 0 24.760810 5.226861 -4.613774 -2135 302 4 0 24.701632 4.684738 -6.052735 -2136 303 6 0 17.563599 12.903092 3.658695 -2137 303 4 0 17.685848 13.560550 2.940588 -2138 303 4 0 16.898391 13.306778 4.183635 -2139 304 6 0 4.174461 14.293392 18.270873 -2140 304 4 0 4.252009 13.308189 18.184247 -2141 304 4 0 3.284820 14.507614 18.560426 -2142 305 6 0 19.179266 -5.054347 -19.519249 -2143 305 4 0 18.780260 -5.604062 -18.845970 -2144 305 4 0 19.534147 -5.684633 -20.141388 -2145 306 6 0 15.658994 11.957779 13.199900 -2146 306 4 0 15.623319 12.838749 12.752640 -2147 306 4 0 16.531973 11.890366 13.660327 -2148 307 6 0 24.758272 -19.997077 5.366209 -2149 307 4 0 24.975628 -20.215262 6.282332 -2150 307 4 0 23.761106 -19.988430 5.431807 -2151 308 6 0 -2.249027 18.570837 -6.683241 -2152 308 4 0 -2.430859 18.100958 -7.499568 -2153 308 4 0 -2.994327 18.644727 -6.092295 -2154 309 6 0 3.560378 -14.631233 -16.617924 -2155 309 4 0 3.964695 -14.691511 -15.761000 -2156 309 4 0 3.979389 -13.913756 -17.067597 -2157 310 6 0 -20.545154 -8.912553 -11.230039 -2158 310 4 0 -21.471069 -9.085454 -11.070560 -2159 310 4 0 -20.109583 -8.288894 -10.586743 -2160 311 6 0 -19.728929 -18.157363 9.832477 -2161 311 4 0 -20.527618 -17.995705 9.320962 -2162 311 4 0 -19.366046 -18.994557 9.552804 -2163 312 6 0 -12.565736 15.723300 8.977635 -2164 312 4 0 -13.331978 15.327968 8.600724 -2165 312 4 0 -12.885953 15.953376 9.855856 -2166 313 6 0 7.768656 -13.056656 -8.955241 -2167 313 4 0 8.048624 -13.789739 -8.425150 -2168 313 4 0 8.500788 -12.860524 -9.542256 -2169 314 6 0 17.695317 -0.658526 -5.443674 -2170 314 4 0 16.888949 -0.180431 -5.230393 -2171 314 4 0 17.868907 -0.568768 -6.336008 -2172 315 6 0 -26.474265 -17.668366 15.551800 -2173 315 4 0 -25.973432 -16.911585 15.255881 -2174 315 4 0 -26.867392 -18.124201 14.764520 -2175 316 6 0 20.955024 16.299890 1.156790 -2176 316 4 0 20.921523 15.384753 1.335509 -2177 316 4 0 20.079452 16.568627 1.085050 -2178 317 6 0 -23.821616 -1.174086 5.308601 -2179 317 4 0 -24.669920 -1.473611 4.967755 -2180 317 4 0 -23.878862 -0.261519 5.469448 -2181 318 6 0 -25.063965 -17.135593 -5.451522 -2182 318 4 0 -24.564833 -16.443850 -5.938694 -2183 318 4 0 -25.016214 -17.933665 -5.953179 -2184 319 6 0 8.668628 -10.867057 3.901078 -2185 319 4 0 7.746163 -11.110803 3.959883 -2186 319 4 0 8.752868 -10.022287 4.307352 -2187 320 6 0 5.527084 -9.208555 11.411321 -2188 320 4 0 4.725607 -8.751662 11.714973 -2189 320 4 0 5.164735 -10.130404 11.316322 -2190 321 6 0 -9.337532 -6.457757 20.443267 -2191 321 4 0 -9.836709 -6.506988 19.607051 -2192 321 4 0 -8.808476 -7.295450 20.450087 -2193 322 6 0 19.513522 2.780765 9.780761 -2194 322 4 0 19.329574 3.702885 9.602934 -2195 322 4 0 18.756331 2.266956 9.355945 -2196 323 6 0 -0.037870 9.082570 10.914997 -2197 323 4 0 -0.144923 8.896093 11.865591 -2198 323 4 0 0.659909 9.734037 10.785946 -2199 324 6 0 21.027998 -15.348739 14.790857 -2200 324 4 0 21.254465 -15.801776 13.888722 -2201 324 4 0 20.075738 -15.400354 14.845656 -2202 325 6 0 14.156515 -11.391327 -14.361896 -2203 325 4 0 14.547773 -11.645291 -13.478079 -2204 325 4 0 14.944302 -11.067054 -14.899771 -2205 326 6 0 -25.175320 17.336673 -10.823444 -2206 326 4 0 -24.334636 17.464575 -11.235937 -2207 326 4 0 -25.742033 18.106292 -10.995823 -2208 327 6 0 -4.110604 17.298456 -14.084863 -2209 327 4 0 -5.063030 17.631527 -14.014860 -2210 327 4 0 -3.534872 17.849349 -13.549744 -2211 328 6 0 -8.725501 -4.824788 13.985429 -2212 328 4 0 -8.885224 -4.493817 14.844915 -2213 328 4 0 -9.307957 -4.341036 13.364528 -2214 329 6 0 -16.804142 -4.642352 -8.769233 -2215 329 4 0 -16.450670 -4.499749 -7.869595 -2216 329 4 0 -16.368056 -3.963859 -9.273107 -2217 330 6 0 -13.154274 13.347332 -10.792162 -2218 330 4 0 -13.404917 13.942330 -10.034598 -2219 330 4 0 -12.589084 12.641097 -10.473229 -2220 331 6 0 -8.087285 12.645852 17.838668 -2221 331 4 0 -8.371003 13.597239 17.804934 -2222 331 4 0 -8.469236 12.290110 16.988633 -2223 332 6 0 -22.931798 10.095495 10.652715 -2224 332 4 0 -23.213802 9.766315 11.531742 -2225 332 4 0 -23.320207 11.046413 10.700380 -2226 333 6 0 -20.983751 11.377312 6.751864 -2227 333 4 0 -21.503099 10.599928 6.692621 -2228 333 4 0 -21.162587 11.703483 7.660694 -2229 334 6 0 -9.661190 -11.046578 19.483449 -2230 334 4 0 -9.724620 -11.203957 20.428241 -2231 334 4 0 -9.182029 -11.809683 19.119545 -2232 335 6 0 20.353500 0.575918 7.152755 -2233 335 4 0 20.303576 0.620770 8.117649 -2234 335 4 0 20.337320 -0.339163 6.903512 -2235 336 6 0 15.990143 -2.457675 4.143017 -2236 336 4 0 15.489807 -1.953955 3.480334 -2237 336 4 0 15.653499 -2.040453 4.954556 -2238 337 6 0 -2.567783 16.482281 -16.807948 -2239 337 4 0 -3.050946 16.892783 -16.078496 -2240 337 4 0 -2.535318 17.087619 -17.572948 -2241 338 6 0 -16.459463 12.994478 3.247220 -2242 338 4 0 -16.263104 13.723100 3.963882 -2243 338 4 0 -16.915538 12.273221 3.618885 -2244 339 6 0 -19.849611 -12.213163 -10.741659 -2245 339 4 0 -19.664050 -11.750480 -11.517833 -2246 339 4 0 -20.220973 -11.559473 -10.070660 -2247 340 6 0 9.529408 -8.147204 4.860752 -2248 340 4 0 9.247691 -7.588893 5.626073 -2249 340 4 0 10.362750 -8.519549 5.100951 -2250 341 6 0 21.538384 -19.843213 20.537686 -2251 341 4 0 20.838857 -19.226662 20.298246 -2252 341 4 0 21.322950 -20.195215 21.445033 -2253 342 6 0 -17.414751 11.192172 -0.613866 -2254 342 4 0 -16.961551 11.804357 -1.153593 -2255 342 4 0 -16.725569 10.585952 -0.366735 -2256 343 6 0 -21.091905 1.428060 -3.164120 -2257 343 4 0 -21.397983 0.608166 -3.585164 -2258 343 4 0 -21.036566 1.285518 -2.209763 -2259 344 6 0 4.570809 -15.227797 -13.905090 -2260 344 4 0 5.091400 -16.090349 -13.835376 -2261 344 4 0 4.857834 -14.567263 -13.304845 -2262 345 6 0 10.258640 0.903759 11.623534 -2263 345 4 0 10.598017 1.120991 12.514742 -2264 345 4 0 10.521679 1.552470 11.006853 -2265 346 6 0 17.642778 19.808652 2.346246 -2266 346 4 0 17.869355 20.445525 1.653123 -2267 346 4 0 18.518553 19.467904 2.662406 -2268 347 6 0 -22.563090 -16.244370 16.474521 -2269 347 4 0 -22.037402 -15.816362 17.175370 -2270 347 4 0 -22.163193 -17.008155 16.111897 -2271 348 6 0 -21.737447 10.632642 0.323883 -2272 348 4 0 -22.138870 9.972645 -0.310600 -2273 348 4 0 -20.878663 10.242561 0.662313 -2274 349 6 0 4.943953 4.514136 10.142833 -2275 349 4 0 4.093975 4.955485 10.181030 -2276 349 4 0 5.290181 4.560969 11.077254 -2277 350 6 0 27.098096 16.972617 9.553607 -2278 350 4 0 27.164532 17.549674 10.320006 -2279 350 4 0 26.222145 17.230319 9.158216 -2280 351 6 0 9.975471 10.519219 19.375075 -2281 351 4 0 10.438521 9.921274 18.809666 -2282 351 4 0 10.113621 10.195006 20.328269 -2283 352 6 0 19.572560 8.531305 -14.059063 -2284 352 4 0 20.062311 8.733262 -13.213496 -2285 352 4 0 20.153062 7.889577 -14.538183 -2286 353 6 0 -7.918488 -2.954663 -18.780336 -2287 353 4 0 -7.314540 -2.910798 -19.514402 -2288 353 4 0 -8.797924 -3.116600 -19.166228 -2289 354 6 0 19.686374 -16.545236 11.269807 -2290 354 4 0 18.989129 -17.260241 11.377153 -2291 354 4 0 19.219253 -15.710481 11.534976 -2292 355 6 0 27.391573 13.462198 15.739536 -2293 355 4 0 26.622656 13.814429 16.131734 -2294 355 4 0 28.086271 13.184682 16.372753 -2295 356 6 0 18.671829 14.132646 1.432787 -2296 356 4 0 18.377115 15.035385 1.296775 -2297 356 4 0 19.190360 13.851325 0.615983 -2298 357 6 0 -12.681771 -19.875375 -9.428073 -2299 357 4 0 -12.883609 -20.344329 -8.608964 -2300 357 4 0 -13.567320 -19.451635 -9.646126 -2301 358 6 0 10.029899 9.448526 2.506329 -2302 358 4 0 9.228082 9.803143 2.872633 -2303 358 4 0 10.370666 8.711255 3.072050 -2304 359 6 0 6.829895 1.451627 -19.901465 -2305 359 4 0 5.933644 1.521889 -20.328666 -2306 359 4 0 6.997933 0.508973 -20.108952 -2307 360 6 0 11.280235 -14.880225 18.973288 -2308 360 4 0 11.853282 -14.806884 19.759711 -2309 360 4 0 11.206610 -13.922929 18.647648 -2310 361 6 0 -13.509311 20.508361 -14.696662 -2311 361 4 0 -13.366236 21.153458 -13.979706 -2312 361 4 0 -13.642549 19.724179 -14.192639 -2313 362 6 0 15.445671 -17.794973 -8.479139 -2314 362 4 0 14.669400 -17.783629 -7.901271 -2315 362 4 0 15.605108 -18.746647 -8.547881 -2316 363 6 0 -18.852558 16.377330 10.008262 -2317 363 4 0 -18.954566 15.472318 9.697097 -2318 363 4 0 -18.836824 16.305839 10.975588 -2319 364 6 0 -3.265075 16.259228 2.098989 -2320 364 4 0 -3.687496 16.647682 2.840607 -2321 364 4 0 -3.231168 15.327934 2.400445 -2322 365 6 0 23.408970 8.557256 -2.138126 -2323 365 4 0 23.726381 8.828223 -3.046334 -2324 365 4 0 24.153951 8.006209 -1.806696 -2325 366 6 0 -18.228938 -7.461297 -20.804424 -2326 366 4 0 -17.795687 -7.325321 -21.656583 -2327 366 4 0 -19.188295 -7.558977 -20.991723 -2328 367 6 0 14.146043 8.886880 -14.615085 -2329 367 4 0 13.553393 8.171127 -14.600739 -2330 367 4 0 15.003303 8.599303 -14.311172 -2331 368 6 0 20.665164 -4.419654 -16.715421 -2332 368 4 0 20.745422 -5.254288 -17.245683 -2333 368 4 0 20.538188 -3.785743 -17.440686 -2334 369 6 0 -26.165001 -17.430791 -11.871737 -2335 369 4 0 -26.769662 -17.569088 -12.614295 -2336 369 4 0 -25.372303 -17.816712 -12.251152 -2337 370 6 0 8.380243 12.002311 -18.225092 -2338 370 4 0 9.331509 12.039099 -17.900481 -2339 370 4 0 7.935426 11.441291 -17.531137 -2340 371 6 0 16.095732 -15.248679 -18.961804 -2341 371 4 0 16.404115 -16.023436 -19.441838 -2342 371 4 0 15.279718 -15.501183 -18.509138 -2343 372 6 0 22.345963 -0.521889 9.487232 -2344 372 4 0 22.570555 0.299269 9.062706 -2345 372 4 0 21.500534 -0.394595 9.878388 -2346 373 6 0 -5.612444 19.185073 -9.536350 -2347 373 4 0 -5.038468 18.530538 -9.043403 -2348 373 4 0 -6.014867 19.664271 -8.828529 -2349 374 6 0 -25.317965 -13.476019 -10.680751 -2350 374 4 0 -24.422815 -13.795959 -10.857483 -2351 374 4 0 -25.587407 -14.286723 -10.139795 -2352 375 6 0 5.097575 -2.791870 -18.340648 -2353 375 4 0 5.426002 -3.124971 -17.421700 -2354 375 4 0 5.173769 -1.845992 -18.214725 -2355 376 6 0 -12.050426 13.594034 -0.308748 -2356 376 4 0 -12.143354 14.332220 -0.865135 -2357 376 4 0 -12.835416 13.379684 0.170780 -2358 377 6 0 21.220086 12.431770 7.373850 -2359 377 4 0 20.289621 12.356271 7.355050 -2360 377 4 0 21.528409 11.600369 6.969319 -2361 378 6 0 -11.849558 -15.011079 -4.217755 -2362 378 4 0 -12.535045 -15.564610 -4.601476 -2363 378 4 0 -11.261594 -15.726054 -3.732481 -2364 379 6 0 19.540600 10.648547 -0.222993 -2365 379 4 0 19.073765 10.676651 0.596923 -2366 379 4 0 19.853650 11.516176 -0.351029 -2367 380 6 0 -1.367659 10.060973 3.255905 -2368 380 4 0 -0.787645 10.846481 3.221548 -2369 380 4 0 -0.921325 9.404127 2.683633 -2370 381 6 0 17.574245 20.192556 -13.486878 -2371 381 4 0 18.041333 19.630746 -14.072375 -2372 381 4 0 18.127340 20.293838 -12.705179 -2373 382 6 0 -18.105957 7.325844 1.685035 -2374 382 4 0 -17.284929 7.597738 2.015915 -2375 382 4 0 -18.515197 8.193099 1.440712 -2376 383 6 0 -25.771851 -0.494052 1.833459 -2377 383 4 0 -26.562791 0.014660 2.156519 -2378 383 4 0 -25.800109 -0.615443 0.880744 -2379 384 6 0 13.515684 3.091718 8.129575 -2380 384 4 0 12.824035 3.780462 8.011639 -2381 384 4 0 13.855067 3.149101 9.026041 -2382 385 6 0 15.024255 -12.331971 18.507086 -2383 385 4 0 14.688886 -12.986046 17.868523 -2384 385 4 0 14.285850 -11.759175 18.796860 -2385 386 6 0 10.503062 -17.208661 -17.537094 -2386 386 4 0 10.869560 -17.224545 -18.470986 -2387 386 4 0 10.144441 -18.040582 -17.343990 -2388 387 6 0 2.330431 13.849933 -16.758821 -2389 387 4 0 1.519885 13.548197 -17.169816 -2390 387 4 0 2.257199 14.793756 -16.760513 -2391 388 6 0 -23.129172 -9.148548 -12.092521 -2392 388 4 0 -24.075243 -8.995756 -12.000743 -2393 388 4 0 -23.086180 -10.039746 -12.445685 -2394 389 6 0 -17.448662 -1.079141 -7.931513 -2395 389 4 0 -17.738453 -1.885709 -7.374659 -2396 389 4 0 -18.172042 -1.099635 -8.625421 -2397 390 6 0 24.048570 -3.763661 -7.564125 -2398 390 4 0 24.193240 -3.884883 -6.642519 -2399 390 4 0 24.456227 -4.566888 -7.925689 -2400 391 6 0 -17.808703 -19.337398 7.373130 -2401 391 4 0 -17.303175 -20.173651 7.501985 -2402 391 4 0 -17.692612 -19.135904 6.461238 -2403 392 6 0 4.319079 -18.666468 -6.315988 -2404 392 4 0 4.318654 -19.531271 -6.749054 -2405 392 4 0 3.377567 -18.420225 -6.140192 -2406 393 6 0 15.744362 14.892988 2.660633 -2407 393 4 0 15.944482 15.856708 2.714939 -2408 393 4 0 15.301384 14.836913 1.848608 -2409 394 6 0 -6.829329 -18.727707 2.030136 -2410 394 4 0 -6.415578 -18.452019 2.842593 -2411 394 4 0 -6.067476 -19.005491 1.466821 -2412 395 6 0 24.121188 19.977112 -20.354495 -2413 395 4 0 24.224055 19.319758 -19.652345 -2414 395 4 0 24.762727 19.635175 -20.939363 -2415 396 6 0 10.579259 -12.534608 5.151755 -2416 396 4 0 9.930043 -12.025918 4.646940 -2417 396 4 0 11.359927 -12.071097 4.861131 -2418 397 6 0 5.967673 -14.216687 -10.676351 -2419 397 4 0 6.631855 -14.774737 -11.170158 -2420 397 4 0 6.490580 -13.637897 -10.118514 -2421 398 6 0 18.539687 -16.102929 15.331204 -2422 398 4 0 18.327655 -16.200138 16.203787 -2423 398 4 0 17.897003 -15.568195 14.864351 -2424 399 6 0 -2.895055 -4.676531 11.113797 -2425 399 4 0 -2.434824 -5.435723 10.710060 -2426 399 4 0 -2.231401 -4.035506 11.395814 -2427 400 6 0 -8.133832 14.629593 7.309404 -2428 400 4 0 -8.851831 15.090624 7.871798 -2429 400 4 0 -7.946895 13.906109 7.942402 -2430 401 6 0 22.250798 0.698906 -0.231699 -2431 401 4 0 22.200775 1.664146 -0.197509 -2432 401 4 0 22.955911 0.389699 -0.887067 -2433 402 6 0 4.057613 14.734523 9.271521 -2434 402 4 0 3.560432 15.591515 9.153949 -2435 402 4 0 4.938114 14.882755 8.921185 -2436 403 6 0 -17.698257 12.666615 -4.894250 -2437 403 4 0 -17.252884 12.676027 -4.012690 -2438 403 4 0 -18.619276 12.371224 -4.622833 -2439 404 6 0 26.668158 -12.819700 -1.311515 -2440 404 4 0 27.032009 -13.646800 -1.097954 -2441 404 4 0 26.646890 -12.850693 -2.254784 -2442 405 6 0 7.224554 13.850996 3.318452 -2443 405 4 0 8.019795 14.275937 3.600876 -2444 405 4 0 7.668540 12.980654 3.041459 -2445 406 6 0 8.952709 -7.047293 -13.075849 -2446 406 4 0 9.898167 -6.904505 -13.302591 -2447 406 4 0 8.562667 -6.214154 -12.992709 -2448 407 6 0 -17.814401 -1.840934 -1.803929 -2449 407 4 0 -18.744975 -1.741200 -1.902642 -2450 407 4 0 -17.699335 -2.395812 -1.018915 -2451 408 6 0 -24.621095 6.164997 -14.673611 -2452 408 4 0 -24.877382 5.755063 -13.785112 -2453 408 4 0 -23.950276 6.830635 -14.339769 -2454 409 6 0 10.479140 -19.025039 18.297194 -2455 409 4 0 11.349364 -18.876899 18.653004 -2456 409 4 0 10.644550 -19.606803 17.504887 -2457 410 6 0 -19.101403 14.252398 -1.786055 -2458 410 4 0 -19.573879 14.657593 -2.525389 -2459 410 4 0 -19.587903 13.601901 -1.323620 -2460 411 6 0 6.717226 1.088539 17.700070 -2461 411 4 0 6.231555 1.199419 18.516697 -2462 411 4 0 6.881490 0.099135 17.787770 -2463 412 6 0 -13.643189 -7.863866 -8.730575 -2464 412 4 0 -14.517866 -7.638837 -9.023604 -2465 412 4 0 -13.154332 -7.346815 -9.390510 -2466 413 6 0 -17.730487 0.990816 -0.622980 -2467 413 4 0 -17.303015 0.205330 -0.935730 -2468 413 4 0 -17.531444 1.017418 0.308170 -2469 414 6 0 25.260176 -10.957318 6.206094 -2470 414 4 0 25.876991 -10.477352 5.676397 -2471 414 4 0 24.475935 -10.963099 5.603334 -2472 415 6 0 14.205628 -17.408033 -13.601399 -2473 415 4 0 14.188193 -18.247713 -13.204445 -2474 415 4 0 13.713279 -17.625825 -14.405922 -2475 416 6 0 -20.784853 -15.686238 -5.898849 -2476 416 4 0 -19.875611 -15.547599 -5.727799 -2477 416 4 0 -21.245430 -14.929289 -5.375604 -2478 417 6 0 -22.633197 8.330983 -13.909999 -2479 417 4 0 -22.233520 9.245054 -13.847024 -2480 417 4 0 -21.843881 7.942242 -14.256165 -2481 418 6 0 11.786714 0.286536 -14.937634 -2482 418 4 0 11.786532 -0.671475 -15.215390 -2483 418 4 0 11.605445 0.272418 -13.981805 -2484 419 6 0 1.681240 0.254113 10.330852 -2485 419 4 0 1.597166 -0.618385 10.733271 -2486 419 4 0 1.413887 0.849687 11.007136 -2487 420 6 0 6.751727 13.837704 8.238736 -2488 420 4 0 6.439245 13.979946 7.299037 -2489 420 4 0 7.165300 14.697405 8.431164 -2490 421 6 0 22.234756 20.556412 6.164713 -2491 421 4 0 21.672715 21.351790 6.258812 -2492 421 4 0 21.702890 19.818097 6.555926 -2493 422 6 0 17.385018 20.449668 10.876882 -2494 422 4 0 16.551469 20.156010 10.407413 -2495 422 4 0 17.440995 21.384757 10.538556 -2496 423 6 0 17.700641 4.527370 19.573010 -2497 423 4 0 17.031995 4.431285 20.256942 -2498 423 4 0 17.481318 3.724034 19.023628 -2499 424 6 0 0.483339 18.111382 -1.823860 -2500 424 4 0 0.218803 18.655109 -1.106869 -2501 424 4 0 1.294713 18.496788 -2.211913 -2502 425 6 0 22.943918 -17.096855 -14.079609 -2503 425 4 0 22.830905 -16.325512 -14.742916 -2504 425 4 0 22.793828 -16.695124 -13.249381 -2505 426 6 0 -12.197414 -2.755310 -15.143763 -2506 426 4 0 -11.972492 -3.409760 -15.785801 -2507 426 4 0 -11.687560 -1.995802 -15.449188 -2508 427 6 0 26.233813 3.059744 -20.109192 -2509 427 4 0 25.634066 3.752709 -19.758728 -2510 427 4 0 26.841050 3.505495 -20.746283 -2511 428 6 0 -0.398685 9.886291 -12.320899 -2512 428 4 0 -0.971500 9.110158 -12.271110 -2513 428 4 0 -0.140227 10.055684 -11.384852 -2514 429 6 0 24.766172 -8.159537 20.532359 -2515 429 4 0 24.676407 -7.239089 20.840721 -2516 429 4 0 23.932220 -8.459730 20.138818 -2517 430 6 0 -13.286555 16.304911 0.900630 -2518 430 4 0 -13.716595 15.953327 1.640887 -2519 430 4 0 -12.366691 16.365858 1.124146 -2520 431 6 0 23.399832 -13.989313 -14.426821 -2521 431 4 0 22.828210 -13.569339 -13.765880 -2522 431 4 0 23.255649 -13.414985 -15.246789 -2523 432 6 0 -22.204092 -4.611638 18.736383 -2524 432 4 0 -21.249902 -4.938147 18.770328 -2525 432 4 0 -22.211606 -3.716829 18.428273 -2526 433 6 0 21.224851 -14.221140 4.789172 -2527 433 4 0 20.596044 -14.495409 5.464993 -2528 433 4 0 21.036876 -14.781346 3.969428 -2529 434 6 0 -0.044311 17.960476 1.830489 -2530 434 4 0 -0.313520 17.147157 1.446425 -2531 434 4 0 -0.796207 18.542831 1.866711 -2532 435 6 0 -18.246500 10.701990 6.592891 -2533 435 4 0 -19.216406 10.992455 6.669125 -2534 435 4 0 -18.267435 9.771442 6.876019 -2535 436 6 0 -0.694143 4.494214 14.021020 -2536 436 4 0 -1.277964 4.997681 13.392435 -2537 436 4 0 -1.155981 4.663647 14.857205 -2538 437 6 0 22.107052 12.819546 -9.903327 -2539 437 4 0 21.296704 13.306649 -9.951121 -2540 437 4 0 22.688713 13.295428 -10.537192 -2541 438 6 0 15.302055 -5.253465 4.034438 -2542 438 4 0 15.326181 -4.291521 3.882146 -2543 438 4 0 16.042293 -5.540500 3.526531 -2544 439 6 0 23.950953 1.271229 5.710913 -2545 439 4 0 23.173495 0.716989 5.765239 -2546 439 4 0 24.051944 1.770274 6.552925 -2547 440 6 0 14.279151 12.647971 15.806599 -2548 440 4 0 14.591090 12.573140 14.893038 -2549 440 4 0 13.381765 12.300162 15.960467 -2550 441 6 0 15.038801 -1.661905 6.589100 -2551 441 4 0 15.892587 -1.551660 6.975739 -2552 441 4 0 14.462182 -0.875051 6.734929 -2553 442 6 0 -6.429505 -9.279231 12.087220 -2554 442 4 0 -6.701830 -10.093703 11.622225 -2555 442 4 0 -5.612815 -9.032770 11.586921 -2556 443 6 0 11.290924 -10.372276 7.217133 -2557 443 4 0 10.622389 -10.955150 6.788259 -2558 443 4 0 11.616275 -9.796597 6.503882 -2559 444 6 0 -24.866907 -13.913179 10.222650 -2560 444 4 0 -24.271979 -13.182736 9.950447 -2561 444 4 0 -25.017302 -14.420326 9.408453 -2562 445 6 0 -27.314146 -19.793576 17.380891 -2563 445 4 0 -27.699149 -20.386657 16.714229 -2564 445 4 0 -26.959051 -19.085769 16.826343 -2565 446 6 0 12.965414 4.595141 18.162499 -2566 446 4 0 13.458928 3.797998 18.472673 -2567 446 4 0 12.462784 4.369395 17.349650 -2568 447 6 0 19.720286 6.716538 19.074363 -2569 447 4 0 18.977040 6.161032 19.255447 -2570 447 4 0 20.199596 6.784088 19.921433 -2571 448 6 0 -17.837323 -10.531279 11.466891 -2572 448 4 0 -18.443320 -10.286485 12.180075 -2573 448 4 0 -17.136906 -10.892709 12.057832 -2574 449 6 0 3.118617 16.201513 -14.560896 -2575 449 4 0 2.524275 15.456086 -14.261283 -2576 449 4 0 3.153477 16.211998 -15.545130 -2577 450 6 0 15.713269 9.977240 -3.550942 -2578 450 4 0 16.125798 10.839790 -3.855082 -2579 450 4 0 16.256998 9.663172 -2.774134 -2580 451 6 0 13.404328 14.288352 8.236302 -2581 451 4 0 13.804031 15.222512 8.339581 -2582 451 4 0 14.094703 13.583706 8.316160 -2583 452 6 0 1.715242 -17.595877 -5.517990 -2584 452 4 0 1.864739 -16.803207 -5.011472 -2585 452 4 0 1.121502 -17.292257 -6.152942 -2586 453 6 0 11.186181 -15.378074 -8.941210 -2587 453 4 0 10.964916 -15.109818 -9.814041 -2588 453 4 0 11.164732 -14.643976 -8.304569 -2589 454 6 0 -25.412651 0.765668 -5.618949 -2590 454 4 0 -25.840497 0.596705 -6.434188 -2591 454 4 0 -26.027451 1.074079 -4.940438 -2592 455 6 0 -11.380143 13.107124 -18.001950 -2593 455 4 0 -12.159770 13.386797 -17.518060 -2594 455 4 0 -11.627822 13.258638 -18.958908 -2595 456 6 0 7.443094 19.776722 19.670510 -2596 456 4 0 6.730151 19.191868 19.918965 -2597 456 4 0 7.622698 19.719431 18.722036 -2598 457 6 0 24.425946 4.299128 7.836287 -2599 457 4 0 24.143986 5.210765 7.985415 -2600 457 4 0 24.990386 4.054602 8.572061 -2601 458 6 0 -3.501704 -11.679155 -10.742632 -2602 458 4 0 -4.397462 -12.025343 -10.633214 -2603 458 4 0 -3.405610 -11.663721 -11.695424 -2604 459 6 0 0.913373 -18.230470 16.876362 -2605 459 4 0 0.053834 -18.577145 16.706546 -2606 459 4 0 1.398023 -19.065707 17.119688 -2607 460 6 0 -9.901596 19.393938 15.691257 -2608 460 4 0 -9.078500 18.954279 15.490614 -2609 460 4 0 -10.185869 18.992605 16.470215 -2610 461 6 0 17.500333 8.706246 -1.323866 -2611 461 4 0 18.176182 9.357546 -1.088149 -2612 461 4 0 17.886380 7.895975 -1.087485 -2613 462 6 0 -24.806806 -14.651049 -14.711674 -2614 462 4 0 -23.905722 -14.363057 -14.892641 -2615 462 4 0 -25.324843 -13.797568 -14.671497 -2616 463 6 0 -11.922848 -15.711273 -13.536344 -2617 463 4 0 -11.771327 -16.170114 -14.379176 -2618 463 4 0 -11.859275 -16.406199 -12.902056 -2619 464 6 0 -27.003017 7.585104 3.060101 -2620 464 4 0 -26.800446 6.932155 2.407207 -2621 464 4 0 -26.438815 7.393710 3.843574 -2622 465 6 0 -10.312090 7.223617 10.185454 -2623 465 4 0 -10.405406 7.379966 11.161275 -2624 465 4 0 -9.783333 6.436443 10.181461 -2625 466 6 0 23.537015 20.390749 -9.649267 -2626 466 4 0 23.323982 21.198505 -9.168669 -2627 466 4 0 23.931089 19.837314 -8.973454 -2628 467 6 0 -17.448795 -20.856696 -12.629322 -2629 467 4 0 -17.613855 -21.585186 -13.226336 -2630 467 4 0 -18.268235 -20.483922 -12.239203 -2631 468 6 0 -5.704053 -12.831319 -13.206852 -2632 468 4 0 -6.332034 -12.109323 -13.311978 -2633 468 4 0 -4.837836 -12.573450 -13.575508 -2634 469 6 0 -7.475606 18.168410 15.238194 -2635 469 4 0 -6.927022 17.679409 15.798229 -2636 469 4 0 -6.978971 18.983237 14.964387 -2637 470 6 0 23.258739 11.168040 16.596096 -2638 470 4 0 23.818087 11.847416 16.270136 -2639 470 4 0 23.610710 10.307417 16.344734 -2640 471 6 0 3.146606 8.327361 -18.713397 -2641 471 4 0 3.334432 7.845623 -19.520851 -2642 471 4 0 3.621381 9.175132 -18.785471 -2643 472 6 0 0.508878 16.181859 6.176221 -2644 472 4 0 1.478661 16.383107 6.127134 -2645 472 4 0 0.329178 16.140784 7.185704 -2646 473 6 0 -11.810390 15.699273 5.840977 -2647 473 4 0 -12.031355 16.450687 6.361038 -2648 473 4 0 -10.941390 15.840688 5.470174 -2649 474 6 0 16.703781 -6.435675 -7.458235 -2650 474 4 0 15.950366 -6.851824 -7.907248 -2651 474 4 0 16.319676 -6.119538 -6.579472 -2652 475 6 0 -16.104630 7.738737 15.683306 -2653 475 4 0 -15.741449 7.072122 15.101362 -2654 475 4 0 -15.325944 8.330995 15.966646 -2655 476 6 0 -12.982372 -5.391773 13.641043 -2656 476 4 0 -13.067158 -6.334773 13.565642 -2657 476 4 0 -13.835584 -5.074352 13.303582 -2658 477 6 0 -0.691433 15.384761 -9.798051 -2659 477 4 0 0.035655 15.975465 -9.534555 -2660 477 4 0 -1.411870 15.925295 -10.115684 -2661 478 6 0 22.895397 13.997330 -2.879616 -2662 478 4 0 23.276050 14.805518 -2.488993 -2663 478 4 0 21.981907 14.160579 -3.026251 -2664 479 6 0 -6.947442 -13.379975 4.783672 -2665 479 4 0 -6.469058 -13.127559 4.014561 -2666 479 4 0 -7.365275 -12.581164 5.147764 -2667 480 6 0 -6.156966 10.605862 2.666376 -2668 480 4 0 -6.752949 10.183956 3.255572 -2669 480 4 0 -5.588229 11.111653 3.195145 -2670 481 6 0 17.104300 -12.560553 4.419376 -2671 481 4 0 16.344172 -13.086998 4.734928 -2672 481 4 0 17.420711 -11.981042 5.141534 -2673 482 6 0 -27.199948 7.334242 -15.333048 -2674 482 4 0 -26.297948 6.895160 -15.306746 -2675 482 4 0 -27.693886 6.547850 -15.268217 -2676 483 6 0 18.024202 -19.856328 -19.395594 -2677 483 4 0 18.487766 -20.698158 -19.394705 -2678 483 4 0 17.496643 -19.929970 -20.262172 -2679 484 6 0 22.144036 -16.812143 16.683717 -2680 484 4 0 21.875393 -16.308766 15.860916 -2681 484 4 0 22.479620 -17.614693 16.338233 -2682 485 6 0 25.514687 -13.472113 7.132093 -2683 485 4 0 25.319079 -13.294653 8.096235 -2684 485 4 0 25.494887 -12.570062 6.821050 -2685 486 6 0 -12.445347 -17.163112 -18.161764 -2686 486 4 0 -13.331012 -16.853903 -17.823843 -2687 486 4 0 -12.475852 -18.105485 -18.058376 -2688 487 6 0 6.245110 16.618836 2.470683 -2689 487 4 0 5.362728 16.987415 2.415415 -2690 487 4 0 6.013984 15.709339 2.583315 -2691 488 6 0 -7.618060 -8.630004 1.461475 -2692 488 4 0 -8.009714 -7.788174 1.663581 -2693 488 4 0 -7.300014 -8.871099 2.309214 -2694 489 6 0 1.276161 -5.724890 -17.027124 -2695 489 4 0 0.639753 -5.451556 -16.374073 -2696 489 4 0 1.572713 -6.534640 -16.615769 -2697 490 6 0 20.941259 -12.865847 16.430327 -2698 490 4 0 21.406858 -13.389929 15.801253 -2699 490 4 0 21.410092 -12.085207 16.695307 -2700 491 6 0 18.670123 -9.367430 14.139852 -2701 491 4 0 17.803568 -9.004865 14.207764 -2702 491 4 0 18.435630 -10.292015 14.355155 -2703 492 6 0 15.733761 -0.209804 0.007017 -2704 492 4 0 15.513443 -0.802742 -0.762427 -2705 492 4 0 15.180436 -0.596633 0.738607 -2706 493 6 0 20.535815 18.401459 7.207233 -2707 493 4 0 20.172747 18.499555 8.120342 -2708 493 4 0 19.715556 18.443909 6.669483 -2709 494 6 0 -19.654075 2.825062 1.617329 -2710 494 4 0 -20.035859 3.209607 2.473368 -2711 494 4 0 -19.137175 3.619122 1.285240 -2712 495 6 0 -5.984107 19.675136 -16.959798 -2713 495 4 0 -5.160819 19.281994 -17.190879 -2714 495 4 0 -5.770973 20.610003 -16.990477 -2715 496 6 0 26.042716 7.197405 -0.343564 -2716 496 4 0 26.688586 6.461363 -0.227844 -2717 496 4 0 25.557638 7.239657 0.456505 -2718 497 6 0 22.024763 3.604615 -12.891547 -2719 497 4 0 21.193970 3.808969 -13.364435 -2720 497 4 0 22.195897 4.401136 -12.384999 -2721 498 6 0 -27.135160 -9.370585 20.643959 -2722 498 4 0 -28.030228 -9.176750 20.474699 -2723 498 4 0 -26.577987 -8.800343 20.128692 -2724 499 6 0 8.395602 -17.119113 3.456766 -2725 499 4 0 8.859834 -17.667269 2.833722 -2726 499 4 0 7.655636 -17.591648 3.745120 -2727 500 6 0 -24.404359 -0.181200 15.657271 -2728 500 4 0 -25.038728 0.161741 16.314921 -2729 500 4 0 -24.896501 -0.279136 14.882179 -2730 501 6 0 -6.891560 5.632315 -20.701537 -2731 501 4 0 -7.366523 6.287143 -21.223329 -2732 501 4 0 -7.630504 5.050659 -20.462604 -2733 502 6 0 -15.566391 -18.747028 -6.177602 -2734 502 4 0 -15.142312 -18.219593 -5.559758 -2735 502 4 0 -16.127679 -19.358388 -5.691405 -2736 503 6 0 -3.401719 -8.548294 5.789954 -2737 503 4 0 -3.203950 -7.652649 5.894670 -2738 503 4 0 -3.475505 -8.723091 4.829013 -2739 504 6 0 -14.869473 17.641299 -11.130330 -2740 504 4 0 -15.356466 18.395479 -10.824746 -2741 504 4 0 -14.164630 17.932079 -11.714816 -2742 505 6 0 -8.566470 9.810858 18.580750 -2743 505 4 0 -7.826026 10.409943 18.459685 -2744 505 4 0 -8.595914 9.242196 17.832030 -2745 506 6 0 15.884351 -0.825682 -9.976397 -2746 506 4 0 16.580456 -1.202192 -10.550817 -2747 506 4 0 16.179129 0.090931 -10.023947 -2748 507 6 0 -6.440363 -16.182406 14.932475 -2749 507 4 0 -5.547886 -16.002472 14.729390 -2750 507 4 0 -6.819275 -16.083044 14.039020 -2751 508 6 0 -15.767451 -12.920838 -5.752541 -2752 508 4 0 -14.944068 -12.805684 -5.287481 -2753 508 4 0 -15.473066 -13.122281 -6.647708 -2754 509 6 0 -17.665031 -20.836176 14.939409 -2755 509 4 0 -16.990389 -21.130134 14.286529 -2756 509 4 0 -18.400170 -20.675073 14.279982 -2757 510 6 0 -22.492854 -19.049287 15.743348 -2758 510 4 0 -23.226808 -19.456562 15.249983 -2759 510 4 0 -22.430818 -19.617870 16.566271 -2760 511 6 0 18.577331 8.130140 -4.339187 -2761 511 4 0 19.102086 8.936870 -4.101075 -2762 511 4 0 17.943090 8.097223 -3.622023 -2763 512 6 0 -8.059195 -11.528283 11.014399 -2764 512 4 0 -8.491272 -11.206486 10.183267 -2765 512 4 0 -7.559001 -12.278215 10.621240 -2766 513 6 0 -0.354476 13.050972 -11.242317 -2767 513 4 0 -0.049943 12.197330 -10.889757 -2768 513 4 0 -0.319360 13.679003 -10.509947 -2769 514 6 0 -22.692724 -6.768839 -13.959385 -2770 514 4 0 -22.638060 -6.234744 -13.112330 -2771 514 4 0 -22.909077 -7.637803 -13.626522 -2772 515 6 0 4.453531 -16.513982 -10.118567 -2773 515 4 0 5.009279 -17.005000 -9.492769 -2774 515 4 0 4.837806 -15.680507 -10.286610 -2775 516 6 0 -14.211895 -3.759096 -20.057898 -2776 516 4 0 -14.318355 -2.866044 -19.740155 -2777 516 4 0 -13.541901 -3.847665 -20.736218 -2778 517 6 0 26.693079 9.858450 -14.505848 -2779 517 4 0 26.995219 9.161898 -15.033866 -2780 517 4 0 25.767285 9.604872 -14.294807 -2781 518 6 0 -1.593304 -2.461499 11.764930 -2782 518 4 0 -0.575245 -2.524541 11.545614 -2783 518 4 0 -1.885036 -1.661756 11.286623 -2784 519 6 0 -19.660824 -20.494500 2.235869 -2785 519 4 0 -20.078029 -21.333649 2.487444 -2786 519 4 0 -19.181632 -20.681107 1.379436 -2787 520 6 0 4.144088 17.144901 -7.996934 -2788 520 4 0 4.141310 16.441147 -7.303669 -2789 520 4 0 3.204041 17.192031 -8.237159 -2790 521 6 0 24.148563 16.188551 14.675204 -2791 521 4 0 24.234269 17.058984 15.034647 -2792 521 4 0 23.773522 16.320292 13.788777 -2793 522 6 0 -11.859704 2.830217 -15.811214 -2794 522 4 0 -12.674780 3.212291 -15.481544 -2795 522 4 0 -11.777095 3.234540 -16.701788 -2796 523 6 0 -14.309989 12.182667 1.560506 -2797 523 4 0 -13.393237 12.215837 1.842065 -2798 523 4 0 -14.715876 12.517376 2.368763 -2799 524 6 0 -7.611903 8.096548 -15.149217 -2800 524 4 0 -8.323994 7.679983 -15.518143 -2801 524 4 0 -6.945506 8.015221 -15.887869 -2802 525 6 0 -19.095296 -11.187670 -3.400222 -2803 525 4 0 -19.337682 -11.939672 -2.902754 -2804 525 4 0 -18.131286 -10.890144 -3.347747 -2805 526 6 0 -3.684618 -18.692360 -9.413075 -2806 526 4 0 -3.418979 -17.929749 -9.940845 -2807 526 4 0 -2.916246 -19.202389 -9.257694 -2808 527 6 0 -24.383366 4.449647 -2.247488 -2809 527 4 0 -24.017217 3.645809 -1.897604 -2810 527 4 0 -24.220917 5.021187 -1.511294 -2811 528 6 0 -19.731647 -12.211221 2.860739 -2812 528 4 0 -19.245645 -12.129462 2.005512 -2813 528 4 0 -20.512036 -12.824760 2.628969 -2814 529 6 0 -4.683560 -15.770086 9.389938 -2815 529 4 0 -5.061246 -15.024625 8.860317 -2816 529 4 0 -5.320477 -16.506457 9.373591 -2817 530 6 0 -4.887399 -5.093738 -15.497549 -2818 530 4 0 -5.401164 -5.893295 -15.248311 -2819 530 4 0 -4.758120 -4.537262 -14.717756 -2820 531 6 0 -14.685481 -17.958902 -3.365836 -2821 531 4 0 -14.177516 -17.147605 -3.110889 -2822 531 4 0 -15.533211 -17.687906 -3.096067 -2823 532 6 0 24.950357 10.761179 -11.253927 -2824 532 4 0 25.623382 10.724523 -10.501653 -2825 532 4 0 24.912589 11.668740 -11.614144 -2826 533 6 0 5.896274 1.022377 5.410141 -2827 533 4 0 5.144364 0.409378 5.470882 -2828 533 4 0 6.702894 0.529043 5.601445 -2829 534 6 0 -10.707964 -12.538200 -15.636360 -2830 534 4 0 -11.433886 -12.205371 -16.086670 -2831 534 4 0 -10.099661 -13.047707 -16.220825 -2832 535 6 0 25.311857 10.178415 6.672916 -2833 535 4 0 25.652073 11.053667 6.645762 -2834 535 4 0 25.462543 9.793786 5.796182 -2835 536 6 0 13.351375 -13.843752 2.567223 -2836 536 4 0 12.454525 -14.099339 2.561046 -2837 536 4 0 13.804123 -14.196570 1.793439 -2838 537 6 0 6.447086 -1.674870 18.025371 -2839 537 4 0 6.966001 -2.437397 17.753314 -2840 537 4 0 5.596824 -1.849843 17.645605 -2841 538 6 0 -7.195562 13.506129 2.012549 -2842 538 4 0 -6.788362 12.635839 2.194379 -2843 538 4 0 -6.577836 13.973475 1.500153 -2844 539 6 0 13.594384 20.297397 2.445796 -2845 539 4 0 13.788282 19.607477 3.108308 -2846 539 4 0 13.006415 19.871282 1.852966 -2847 540 6 0 15.233611 0.850818 -5.243920 -2848 540 4 0 15.311708 1.467460 -4.483590 -2849 540 4 0 15.351381 1.519810 -6.000951 -2850 541 6 0 -21.392858 -6.660913 15.084747 -2851 541 4 0 -21.093136 -6.580317 16.005763 -2852 541 4 0 -20.482050 -6.866879 14.680665 -2853 542 6 0 21.798067 9.236981 0.429299 -2854 542 4 0 22.425954 9.071754 -0.267587 -2855 542 4 0 21.188410 9.810447 0.032847 -2856 543 6 0 -16.844679 -14.439050 3.033305 -2857 543 4 0 -17.236824 -14.606294 2.191567 -2858 543 4 0 -17.149528 -13.681189 3.446869 -2859 544 6 0 -16.118636 -14.695009 11.770906 -2860 544 4 0 -16.061462 -15.566570 12.219315 -2861 544 4 0 -15.401385 -14.815928 11.092232 -2862 545 6 0 -25.116635 -0.336266 -13.211265 -2863 545 4 0 -26.034773 -0.593788 -13.205266 -2864 545 4 0 -25.075870 0.263017 -13.996810 -2865 546 6 0 -20.959975 8.707771 -3.841257 -2866 546 4 0 -20.129335 8.189240 -3.711541 -2867 546 4 0 -21.648123 8.152127 -4.150679 -2868 547 6 0 -16.180937 -14.560529 -11.236167 -2869 547 4 0 -16.474551 -15.471407 -11.472150 -2870 547 4 0 -16.621414 -14.329172 -10.425074 -2871 548 6 0 -13.342695 17.268978 -5.546108 -2872 548 4 0 -13.676329 17.161979 -6.427016 -2873 548 4 0 -13.273106 16.392331 -5.194906 -2874 549 6 0 -24.265742 -14.933019 -6.702562 -2875 549 4 0 -23.594698 -14.475474 -7.192272 -2876 549 4 0 -24.769412 -14.353533 -6.144027 -2877 550 6 0 -7.448634 4.091980 -14.623254 -2878 550 4 0 -8.354031 4.372416 -14.477512 -2879 550 4 0 -7.429422 3.997857 -15.560262 -2880 551 6 0 20.945964 8.392028 7.273218 -2881 551 4 0 20.936526 8.748124 8.157739 -2882 551 4 0 21.409383 8.938927 6.671909 -2883 552 6 0 -18.135613 13.691026 0.855516 -2884 552 4 0 -17.605509 13.473951 1.604996 -2885 552 4 0 -17.989769 12.903203 0.328977 -2886 553 6 0 -26.399609 20.299424 -15.455568 -2887 553 4 0 -26.506532 19.402038 -15.778173 -2888 553 4 0 -27.208559 20.540561 -15.036657 -2889 554 6 0 -3.382080 16.857093 -8.397864 -2890 554 4 0 -3.374084 16.083688 -7.808965 -2891 554 4 0 -4.084724 16.687463 -9.043127 -2892 555 6 0 16.271526 -9.902746 -4.216439 -2893 555 4 0 16.409251 -10.505040 -3.454487 -2894 555 4 0 15.497720 -10.304168 -4.762308 -2895 556 6 0 14.340659 -16.032990 13.215463 -2896 556 4 0 13.501340 -15.882091 13.690140 -2897 556 4 0 14.455052 -15.349188 12.509336 -2898 557 6 0 -0.015146 -13.033200 3.303743 -2899 557 4 0 -0.181704 -13.007242 2.346702 -2900 557 4 0 0.267440 -13.997638 3.485458 -2901 558 6 0 17.219995 5.155984 2.579305 -2902 558 4 0 17.867362 4.521907 2.914585 -2903 558 4 0 17.421034 5.907098 3.091911 -2904 559 6 0 -4.290476 -8.859344 10.315396 -2905 559 4 0 -4.367776 -8.058305 9.793864 -2906 559 4 0 -4.232508 -9.643259 9.792086 -2907 560 6 0 -26.107401 19.840481 -9.535848 -2908 560 4 0 -25.152722 20.076292 -9.710007 -2909 560 4 0 -26.580648 20.657816 -9.784705 -2910 561 6 0 22.430740 12.824805 -18.610921 -2911 561 4 0 22.555563 12.342166 -17.752607 -2912 561 4 0 21.710766 13.488004 -18.415345 -2913 562 6 0 -0.213702 15.539427 8.868930 -2914 562 4 0 0.465115 15.308974 9.514310 -2915 562 4 0 -0.991140 15.165260 9.301737 -2916 563 6 0 10.451773 19.296672 -15.739638 -2917 563 4 0 11.250242 18.716315 -15.675225 -2918 563 4 0 10.166040 19.254066 -16.609341 -2919 564 6 0 -16.340404 20.299845 -6.677501 -2920 564 4 0 -15.394517 20.367214 -6.949699 -2921 564 4 0 -16.411819 19.609339 -6.000069 -2922 565 6 0 17.490554 18.048717 15.249869 -2923 565 4 0 17.383710 17.561453 14.453086 -2924 565 4 0 17.231849 18.986361 14.979711 -2925 566 6 0 -25.356900 0.960567 -15.630378 -2926 566 4 0 -25.668408 1.746466 -16.112686 -2927 566 4 0 -25.749312 0.266373 -16.283472 -2928 567 6 0 -24.523491 12.684913 -13.612913 -2929 567 4 0 -25.162839 13.082234 -14.200312 -2930 567 4 0 -24.857615 11.766450 -13.558078 -2931 568 6 0 -18.320478 -19.787535 -8.552256 -2932 568 4 0 -17.456232 -20.243682 -8.416866 -2933 568 4 0 -18.816764 -20.212417 -7.902570 -2934 569 6 0 -20.122796 -19.443402 14.311268 -2935 569 4 0 -20.955070 -19.458490 14.740741 -2936 569 4 0 -20.448309 -19.736012 13.412761 -2937 570 6 0 15.526182 9.609189 7.445275 -2938 570 4 0 16.546971 9.522464 7.260687 -2939 570 4 0 15.127662 8.717624 7.262881 -2940 571 6 0 21.815800 -13.876078 19.805359 -2941 571 4 0 21.861374 -13.448639 20.652235 -2942 571 4 0 20.873448 -13.977249 19.618277 -2943 572 6 0 -20.455209 -17.485281 2.435687 -2944 572 4 0 -20.514677 -18.504590 2.320539 -2945 572 4 0 -19.650253 -17.416617 3.035233 -2946 573 6 0 12.598962 20.934840 -8.411100 -2947 573 4 0 11.759105 20.691141 -7.924616 -2948 573 4 0 12.471156 20.908914 -9.376870 -2949 574 6 0 -9.216318 -10.756192 8.704342 -2950 574 4 0 -9.035829 -9.823066 8.964150 -2951 574 4 0 -10.158700 -10.965843 8.822969 -2952 575 6 0 15.481710 -19.357119 -11.731342 -2953 575 4 0 16.266851 -18.921549 -11.423511 -2954 575 4 0 15.782813 -20.280095 -11.705706 -2955 576 6 0 -15.247931 17.174276 -3.500551 -2956 576 4 0 -15.486872 16.716297 -4.319984 -2957 576 4 0 -14.488844 17.725770 -3.787040 -2958 577 6 0 13.994416 -17.236082 0.675362 -2959 577 4 0 14.353425 -17.278489 1.570062 -2960 577 4 0 14.236303 -16.341554 0.403337 -2961 578 6 0 -23.467726 19.561551 3.571514 -2962 578 4 0 -24.004822 19.287615 4.359125 -2963 578 4 0 -22.609407 19.390622 3.887076 -2964 579 6 0 -18.884839 -16.840019 19.441419 -2965 579 4 0 -17.972164 -16.942648 19.429089 -2966 579 4 0 -19.117567 -17.305223 18.656489 -2967 580 6 0 -3.304416 17.688255 14.806768 -2968 580 4 0 -3.274068 18.569163 15.273992 -2969 580 4 0 -3.909468 17.884508 14.115697 -2970 581 6 0 -17.284600 -14.419545 -3.713924 -2971 581 4 0 -17.245841 -15.056389 -4.407408 -2972 581 4 0 -16.814676 -13.644893 -4.121390 -2973 582 6 0 -20.198946 13.854179 -11.126603 -2974 582 4 0 -19.842134 14.641594 -10.704689 -2975 582 4 0 -20.994231 13.579588 -10.762730 -2976 583 6 0 19.633175 -4.534579 -1.940156 -2977 583 4 0 20.573656 -4.404910 -1.787896 -2978 583 4 0 19.476036 -5.006335 -2.786939 -2979 584 6 0 -14.050747 -7.840313 -20.451392 -2980 584 4 0 -13.804502 -7.885621 -19.536069 -2981 584 4 0 -14.163116 -8.770871 -20.729134 -2982 585 6 0 -22.035810 -14.696947 -15.342419 -2983 585 4 0 -21.244458 -14.172213 -14.968853 -2984 585 4 0 -21.709618 -15.071176 -16.129917 -2985 586 6 0 24.404519 18.662499 15.604580 -2986 586 4 0 23.649634 19.231742 15.720672 -2987 586 4 0 24.564861 18.257635 16.462026 -2988 587 6 0 -25.023703 1.632995 9.069342 -2989 587 4 0 -24.924833 0.728361 9.205894 -2990 587 4 0 -25.848027 1.691778 8.537435 -2991 588 6 0 -23.501597 20.098664 7.878789 -2992 588 4 0 -23.060988 19.669189 7.073786 -2993 588 4 0 -24.179799 19.453525 8.025704 -2994 589 6 0 -19.949605 3.791557 -8.640569 -2995 589 4 0 -20.735484 4.236110 -9.006112 -2996 589 4 0 -20.021037 3.910265 -7.668204 -2997 590 6 0 -11.039604 7.965462 12.985718 -2998 590 4 0 -11.657528 7.295810 13.344834 -2999 590 4 0 -11.533657 8.735729 12.733347 -3000 591 6 0 -10.874373 -9.234080 16.940331 -3001 591 4 0 -10.287226 -8.454268 16.808084 -3002 591 4 0 -10.829657 -9.367499 17.890097 -3003 592 6 0 -14.385649 -14.739019 19.039927 -3004 592 4 0 -15.014366 -15.430322 18.739868 -3005 592 4 0 -13.950162 -14.385374 18.202705 -3006 593 6 0 -8.943007 -18.707640 -12.863046 -3007 593 4 0 -8.324251 -18.030317 -12.441569 -3008 593 4 0 -8.503951 -19.555164 -12.986191 -3009 594 6 0 -12.368468 -11.299670 18.862003 -3010 594 4 0 -11.462838 -11.162374 19.089512 -3011 594 4 0 -12.285975 -11.967140 18.162474 -3012 595 6 0 -18.864908 10.893225 -18.642183 -3013 595 4 0 -19.737729 11.286548 -18.797146 -3014 595 4 0 -18.291730 11.691326 -18.413733 -3015 596 6 0 13.738555 -10.387697 15.727067 -3016 596 4 0 14.677946 -10.190824 15.738680 -3017 596 4 0 13.381035 -9.878174 14.979047 -3018 597 6 0 -21.819721 -0.482540 -14.130337 -3019 597 4 0 -22.018580 0.101499 -14.814948 -3020 597 4 0 -21.732054 0.043937 -13.284517 -3021 598 6 0 -22.088145 -19.005770 -10.424446 -3022 598 4 0 -22.700458 -18.735873 -11.127116 -3023 598 4 0 -22.265806 -18.243802 -9.851663 -3024 599 6 0 -27.334131 16.862943 6.388414 -3025 599 4 0 -27.128884 17.208336 5.542208 -3026 599 4 0 -28.186942 16.459356 6.245911 -3027 600 6 0 -7.724914 11.617317 -15.852447 -3028 600 4 0 -7.898781 11.683763 -14.888607 -3029 600 4 0 -7.243883 12.459704 -15.934395 -3030 601 6 0 -27.430510 7.062419 7.641894 -3031 601 4 0 -28.241619 7.496835 7.830929 -3032 601 4 0 -26.905937 6.864821 8.456222 -3033 602 6 0 -15.189130 9.068233 11.973047 -3034 602 4 0 -15.507439 9.270556 11.066477 -3035 602 4 0 -16.000569 9.109399 12.508881 -3036 603 6 0 18.197719 -8.444367 -5.807006 -3037 603 4 0 17.669265 -7.953475 -6.477556 -3038 603 4 0 17.491033 -8.840952 -5.199557 -3039 604 6 0 -17.798267 -15.359279 0.720984 -3040 604 4 0 -17.605358 -16.253295 0.449070 -3041 604 4 0 -18.769315 -15.298569 0.739208 -3042 605 6 0 -10.801299 19.625083 -5.021468 -3043 605 4 0 -9.963843 19.123292 -5.234694 -3044 605 4 0 -10.501894 20.547773 -4.927487 -3045 606 6 0 -27.215648 6.353394 -6.216686 -3046 606 4 0 -27.824477 6.975672 -6.597897 -3047 606 4 0 -27.715217 5.539077 -6.142494 -3048 607 6 0 -20.222710 16.482564 20.889728 -3049 607 4 0 -19.409945 15.875063 20.936404 -3050 607 4 0 -20.827135 16.165289 21.596363 -3051 608 6 0 -15.955148 20.970093 -1.473146 -3052 608 4 0 -16.254513 20.076270 -1.042106 -3053 608 4 0 -15.662348 21.552087 -0.814219 -3054 609 6 0 10.807526 -13.982475 1.662510 -3055 609 4 0 10.120672 -14.259351 2.204544 -3056 609 4 0 10.863967 -13.021251 1.772688 -3057 610 6 0 -7.966458 -18.779639 13.245673 -3058 610 4 0 -7.309099 -18.332730 12.718011 -3059 610 4 0 -8.719738 -18.984231 12.613154 -3060 611 6 0 -20.403821 -13.506340 10.662924 -3061 611 4 0 -20.510093 -14.184751 11.331921 -3062 611 4 0 -19.449692 -13.488641 10.607253 -3063 612 6 0 3.347403 17.582790 14.279585 -3064 612 4 0 3.542375 16.697267 14.539882 -3065 612 4 0 3.842808 18.157712 14.875497 -3066 613 6 0 -27.268704 11.599332 7.521962 -3067 613 4 0 -27.319935 12.603952 7.610238 -3068 613 4 0 -27.760414 11.222738 8.251319 -3069 614 6 0 -13.558625 -13.571833 9.018373 -3070 614 4 0 -14.134501 -13.113855 9.622383 -3071 614 4 0 -13.282735 -12.952963 8.287428 -3072 615 6 0 -12.904629 4.779698 8.188511 -3073 615 4 0 -12.946789 5.709486 7.819080 -3074 615 4 0 -13.125056 4.225008 7.389046 -3075 616 6 0 -26.521845 8.632500 -1.585840 -3076 616 4 0 -27.252112 8.571224 -0.926514 -3077 616 4 0 -27.101821 8.697912 -2.395641 -3078 617 6 0 0.711352 18.247453 15.282784 -3079 617 4 0 1.603697 18.249814 14.962197 -3080 617 4 0 0.201613 17.732907 14.670147 -3081 618 6 0 7.113451 16.228888 -1.466776 -3082 618 4 0 7.173117 15.305699 -1.111399 -3083 618 4 0 7.220512 16.670305 -0.601189 -3084 619 6 0 -13.904243 8.625524 20.904818 -3085 619 4 0 -14.598235 8.427161 20.276223 -3086 619 4 0 -13.595573 9.537530 20.812383 -3087 620 6 0 -23.282747 7.422865 -4.367991 -3088 620 4 0 -23.494082 7.124036 -5.259399 -3089 620 4 0 -24.056516 7.114406 -3.864243 -3090 621 6 0 -14.263410 11.647626 -16.485013 -3091 621 4 0 -14.250457 12.591263 -16.217484 -3092 621 4 0 -13.447733 11.223560 -16.266518 -3093 622 6 0 -25.123489 -11.752131 6.663069 -3094 622 4 0 -24.434538 -11.175706 6.315833 -3095 622 4 0 -24.632736 -12.584077 6.767142 -3096 623 6 0 -14.146070 -17.326290 5.680123 -3097 623 4 0 -13.644335 -16.487658 5.902302 -3098 623 4 0 -14.878124 -17.344106 6.279009 -3099 624 6 0 -20.598314 9.096753 20.421892 -3100 624 4 0 -21.420000 9.436011 20.788368 -3101 624 4 0 -20.773261 8.800990 19.535216 -3102 625 6 0 18.231067 -8.355182 -15.374644 -3103 625 4 0 19.158997 -8.699272 -15.469475 -3104 625 4 0 18.162062 -7.866000 -14.601450 -3105 626 6 0 -26.082795 17.419257 -15.113528 -3106 626 4 0 -26.663305 16.880075 -15.659385 -3107 626 4 0 -26.614420 17.764627 -14.366811 -3108 627 6 0 -4.564502 -6.365364 18.192018 -3109 627 4 0 -4.423912 -6.577366 17.248668 -3110 627 4 0 -4.413382 -7.162274 18.732886 -3111 628 6 0 2.994631 -20.344673 -10.462592 -3112 628 4 0 3.336979 -19.647973 -11.071544 -3113 628 4 0 2.839013 -21.162093 -11.031196 -3114 629 6 0 -18.808948 18.745667 8.606647 -3115 629 4 0 -18.793078 17.928925 9.047490 -3116 629 4 0 -19.375318 18.782786 7.854831 -3117 630 6 0 20.293384 6.483656 -8.185168 -3118 630 4 0 19.822775 6.335085 -7.339796 -3119 630 4 0 19.910867 5.733330 -8.676027 -3120 631 6 0 14.001637 -11.377427 6.654390 -3121 631 4 0 14.665802 -10.891103 7.186571 -3122 631 4 0 13.155623 -11.243569 7.110824 -3123 632 6 0 -18.716197 16.452296 -6.146582 -3124 632 4 0 -17.737092 16.308167 -6.065641 -3125 632 4 0 -18.803071 17.441704 -6.266673 -3126 633 6 0 -9.164502 -4.245435 9.687071 -3127 633 4 0 -9.504754 -3.618059 10.271725 -3128 633 4 0 -8.758976 -4.901714 10.277390 -3129 634 6 0 -7.567104 17.996846 -14.273209 -3130 634 4 0 -7.423981 17.432000 -15.103459 -3131 634 4 0 -7.626914 17.354562 -13.501068 -3132 635 6 0 25.957404 18.297560 0.964228 -3133 635 4 0 26.373386 18.902213 1.607245 -3134 635 4 0 24.996135 18.298154 0.948557 -3135 636 6 0 27.365655 -19.507447 4.283366 -3136 636 4 0 27.265808 -18.590346 4.470644 -3137 636 4 0 27.346229 -19.502059 3.318095 -3138 637 6 0 3.399017 3.842973 -14.306661 -3139 637 4 0 3.874219 4.645706 -14.438487 -3140 637 4 0 3.960550 3.060792 -14.302404 -3141 638 6 0 -9.633558 -14.252688 -13.074954 -3142 638 4 0 -10.397961 -14.800052 -13.280458 -3143 638 4 0 -9.599658 -13.580050 -13.748986 -3144 639 6 0 -26.597184 -9.526044 16.214934 -3145 639 4 0 -25.761551 -9.704064 15.705422 -3146 639 4 0 -26.282395 -9.291353 17.107825 -3147 640 6 0 9.904852 -8.080714 13.028578 -3148 640 4 0 9.633649 -8.672937 13.775436 -3149 640 4 0 9.328640 -8.216914 12.289674 -3150 641 6 0 -16.656465 -15.275719 14.920535 -3151 641 4 0 -16.332015 -16.176602 15.149012 -3152 641 4 0 -17.604168 -15.312599 15.097227 -3153 642 6 0 -23.632856 16.383578 4.244499 -3154 642 4 0 -24.439865 15.907903 4.567947 -3155 642 4 0 -23.758905 16.459340 3.297146 -3156 643 6 0 6.174822 3.396366 6.558333 -3157 643 4 0 6.411031 3.086511 7.491490 -3158 643 4 0 5.914298 2.639627 6.072475 -3159 644 6 0 -12.394642 12.999960 5.615295 -3160 644 4 0 -12.767249 13.829992 5.894454 -3161 644 4 0 -11.542368 12.942527 6.067628 -3162 645 6 0 -13.943061 -10.506777 -8.106784 -3163 645 4 0 -14.282580 -10.512566 -7.188555 -3164 645 4 0 -13.832495 -9.541181 -8.393822 -3165 646 6 0 -2.132377 12.062639 -15.645930 -3166 646 4 0 -2.521581 12.726985 -15.116060 -3167 646 4 0 -2.383415 12.256835 -16.605675 -3168 647 6 0 -15.781380 4.295423 -12.837615 -3169 647 4 0 -16.545564 4.857521 -12.623883 -3170 647 4 0 -14.991403 4.649584 -12.386947 -3171 648 6 0 3.657686 -14.899636 11.284985 -3172 648 4 0 4.599918 -15.027083 11.351362 -3173 648 4 0 3.451904 -14.114684 10.742312 -3174 649 6 0 -13.445931 -12.269834 -16.644595 -3175 649 4 0 -13.143553 -12.206221 -17.543310 -3176 649 4 0 -14.277341 -11.802665 -16.570144 -3177 650 6 0 -4.514598 -14.412565 -11.239008 -3178 650 4 0 -4.912249 -14.782052 -10.430067 -3179 650 4 0 -5.207582 -13.911802 -11.682506 -3180 651 6 0 -22.202449 -8.277754 -0.156304 -3181 651 4 0 -21.822932 -9.154115 -0.107154 -3182 651 4 0 -22.081748 -7.881016 0.675063 -3183 652 6 0 5.980605 9.643233 7.937147 -3184 652 4 0 5.778293 9.935793 8.831204 -3185 652 4 0 6.322796 10.408255 7.426496 -3186 653 6 0 -2.201607 -16.515113 -14.210032 -3187 653 4 0 -2.059974 -15.558981 -14.035317 -3188 653 4 0 -1.990188 -17.058199 -13.410631 -3189 654 6 0 18.679591 -18.705711 14.460946 -3190 654 4 0 18.696979 -17.793354 14.872009 -3191 654 4 0 19.598133 -18.732862 14.241557 -3192 655 6 0 -23.704300 9.078870 13.078638 -3193 655 4 0 -23.670653 8.205186 13.541582 -3194 655 4 0 -24.192847 9.646015 13.627775 -3195 656 6 0 -2.173657 16.833015 -11.939576 -3196 656 4 0 -1.811491 16.347920 -12.704849 -3197 656 4 0 -1.445451 17.452841 -11.775832 -3198 657 6 0 13.483501 -11.256705 11.913651 -3199 657 4 0 12.870120 -10.662512 12.431360 -3200 657 4 0 14.331458 -10.851122 11.936251 -3201 658 6 0 24.414471 -17.245267 11.179269 -3202 658 4 0 25.211262 -16.789228 11.385933 -3203 658 4 0 24.640242 -18.219159 11.091473 -3204 659 6 0 11.120331 -15.111988 5.927148 -3205 659 4 0 11.451561 -14.918986 6.814295 -3206 659 4 0 11.019394 -14.187742 5.582882 -3207 660 6 0 12.007104 -9.600387 4.572911 -3208 660 4 0 11.779325 -9.981896 3.630934 -3209 660 4 0 12.299473 -8.663707 4.379041 -3210 661 6 0 6.432204 5.492806 -11.438378 -3211 661 4 0 6.858563 6.325600 -11.691904 -3212 661 4 0 5.497288 5.536187 -11.496269 -3213 662 6 0 -16.803408 -2.309975 -12.525084 -3214 662 4 0 -17.553689 -1.730249 -12.823644 -3215 662 4 0 -17.150179 -3.188627 -12.867169 -3216 663 6 0 -2.408853 19.363640 5.416041 -3217 663 4 0 -2.506588 20.324223 5.172630 -3218 663 4 0 -1.499205 19.245311 4.997471 -3219 664 6 0 18.335645 9.820504 -20.835302 -3220 664 4 0 17.802051 9.406337 -21.556671 -3221 664 4 0 19.054571 10.173338 -21.326492 -3222 665 6 0 14.492400 -0.793925 15.043220 -3223 665 4 0 15.273199 -0.763837 15.602226 -3224 665 4 0 13.903082 -0.202173 15.510237 -3225 666 6 0 -18.990417 -18.003103 -15.160778 -3226 666 4 0 -19.065422 -18.467887 -14.363137 -3227 666 4 0 -18.682751 -18.771930 -15.707456 -3228 667 6 0 -19.355981 10.428580 -15.655699 -3229 667 4 0 -18.958237 10.419569 -16.503824 -3230 667 4 0 -19.555621 9.469325 -15.477396 -3231 668 6 0 -9.689572 -17.625802 20.274891 -3232 668 4 0 -9.638458 -16.856491 19.680753 -3233 668 4 0 -10.446575 -18.157818 20.089513 -3234 669 6 0 15.818186 -2.858530 -17.669337 -3235 669 4 0 15.374117 -2.032149 -17.355590 -3236 669 4 0 16.772354 -2.603400 -17.785321 -3237 670 6 0 4.606592 -16.002710 16.812249 -3238 670 4 0 5.315620 -15.500456 17.249944 -3239 670 4 0 3.799748 -15.479801 16.918622 -3240 671 6 0 -21.513339 9.988705 -9.339870 -3241 671 4 0 -20.667999 10.159257 -9.025723 -3242 671 4 0 -21.969690 9.708425 -8.552482 -3243 672 6 0 22.932065 -4.395951 1.502838 -3244 672 4 0 23.014854 -3.682098 2.132967 -3245 672 4 0 22.755233 -5.203260 2.068576 -3246 673 6 0 -15.865161 20.547416 -16.433392 -3247 673 4 0 -15.771392 21.394273 -16.845693 -3248 673 4 0 -15.137003 20.501933 -15.748936 -3249 674 6 0 25.069907 -16.838970 -4.299599 -3250 674 4 0 25.999382 -16.506367 -4.277797 -3251 674 4 0 24.882196 -17.073394 -3.399165 -3252 675 6 0 12.210843 -6.139817 11.421079 -3253 675 4 0 11.494183 -5.792293 10.826764 -3254 675 4 0 12.753399 -6.598677 10.772296 -3255 676 6 0 -12.958185 15.721214 20.131937 -3256 676 4 0 -12.417015 15.448234 19.335440 -3257 676 4 0 -12.670185 16.622230 20.361377 -3258 677 6 0 -1.787017 -16.482436 -2.383044 -3259 677 4 0 -1.225925 -16.053148 -3.012278 -3260 677 4 0 -2.501380 -15.880251 -2.214679 -3261 678 6 0 -1.190078 -20.139554 1.294226 -3262 678 4 0 -0.299194 -20.371113 0.969279 -3263 678 4 0 -1.688402 -19.692251 0.619486 -3264 679 6 0 1.937567 -19.455705 20.174807 -3265 679 4 0 1.600890 -18.656647 20.650502 -3266 679 4 0 2.270116 -20.076098 20.862273 -3267 680 6 0 -13.809787 16.178967 11.484043 -3268 680 4 0 -14.142545 15.377181 11.850775 -3269 680 4 0 -14.373329 16.882494 11.935295 -3270 681 6 0 17.196672 -3.298677 9.603341 -3271 681 4 0 17.785156 -3.273949 10.352111 -3272 681 4 0 16.328249 -3.307055 9.989818 -3273 682 6 0 -21.793083 12.953802 -3.361588 -3274 682 4 0 -21.341354 13.824014 -3.442583 -3275 682 4 0 -21.956486 12.886091 -2.420332 -3276 683 6 0 24.722833 -20.214271 -1.932412 -3277 683 4 0 24.583170 -20.295689 -2.905459 -3278 683 4 0 25.266330 -20.988208 -1.659517 -3279 684 6 0 13.576953 15.549687 -14.568922 -3280 684 4 0 13.196035 16.082140 -13.845167 -3281 684 4 0 12.903095 14.935032 -14.704323 -3282 685 6 0 24.686323 18.724782 9.264820 -3283 685 4 0 25.356258 19.231143 8.760904 -3284 685 4 0 24.376076 19.091122 10.133820 -3285 686 6 0 10.974277 8.210457 0.042398 -3286 686 4 0 10.346946 8.747962 0.639501 -3287 686 4 0 11.775308 8.082914 0.592641 -3288 687 6 0 15.749941 -9.949096 -10.535727 -3289 687 4 0 14.881677 -9.994266 -10.933909 -3290 687 4 0 16.082746 -9.069742 -10.712222 -3291 688 6 0 20.372551 -2.740524 -20.295283 -3292 688 4 0 19.972569 -3.556917 -19.910575 -3293 688 4 0 21.117159 -2.669954 -19.650483 -3294 689 6 0 -16.130593 19.525141 7.609103 -3295 689 4 0 -16.988329 19.095523 7.574165 -3296 689 4 0 -15.815635 19.368486 8.484111 -3297 690 6 0 -13.620470 -12.179873 -20.763485 -3298 690 4 0 -13.206848 -12.281384 -21.584939 -3299 690 4 0 -13.003543 -11.952064 -20.092320 -3300 691 6 0 -4.286145 -8.076676 -19.850653 -3301 691 4 0 -4.024629 -8.962570 -19.497729 -3302 691 4 0 -4.628013 -8.265378 -20.732144 -3303 692 6 0 18.167149 11.171401 14.365772 -3304 692 4 0 18.072419 11.267858 15.337991 -3305 692 4 0 19.114984 11.092302 14.227006 -3306 693 6 0 -6.484207 14.268929 15.251307 -3307 693 4 0 -5.622289 14.569256 15.414810 -3308 693 4 0 -6.409671 13.589284 14.542615 -3309 694 6 0 -22.009910 15.740037 8.254841 -3310 694 4 0 -21.174881 15.566577 7.788279 -3311 694 4 0 -21.784303 15.725302 9.211467 -3312 695 6 0 -12.075884 4.855934 18.759604 -3313 695 4 0 -11.922580 5.826978 18.890965 -3314 695 4 0 -11.210639 4.506344 19.097368 -3315 696 6 0 10.488011 -18.196911 -8.466384 -3316 696 4 0 10.637969 -17.211540 -8.520849 -3317 696 4 0 11.163762 -18.500106 -9.085738 -3318 697 6 0 1.125820 20.066151 11.277514 -3319 697 4 0 0.488344 19.358887 11.406985 -3320 697 4 0 1.175707 20.424035 12.220043 -3321 698 6 0 1.508244 -2.375369 14.307932 -3322 698 4 0 0.868346 -1.761280 14.698396 -3323 698 4 0 1.257101 -3.281035 14.657092 -3324 699 6 0 8.333201 -20.303098 14.135689 -3325 699 4 0 8.173342 -20.812430 14.996202 -3326 699 4 0 7.563231 -20.469348 13.580696 -3327 700 6 0 7.161769 13.324939 -3.684466 -3328 700 4 0 6.692561 13.032914 -4.505707 -3329 700 4 0 7.435294 14.252208 -3.751921 -3330 701 6 0 -8.368806 1.641675 18.686706 -3331 701 4 0 -7.449000 1.561105 18.992044 -3332 701 4 0 -8.829402 1.367359 19.523867 -3333 702 6 0 4.081470 8.393376 14.788004 -3334 702 4 0 3.416356 8.289314 15.434673 -3335 702 4 0 3.901559 7.693490 14.181822 -3336 703 6 0 -7.418847 -5.372814 17.842250 -3337 703 4 0 -7.820918 -6.206339 17.693835 -3338 703 4 0 -6.460103 -5.466581 17.841167 -3339 704 6 0 -6.272338 -9.280731 3.614771 -3340 704 4 0 -5.671659 -9.851333 3.097194 -3341 704 4 0 -6.583386 -9.880058 4.252855 -3342 705 6 0 26.867212 -7.498721 15.184014 -3343 705 4 0 27.180613 -8.176302 15.786609 -3344 705 4 0 27.338168 -7.770453 14.373438 -3345 706 6 0 9.996033 -14.570233 13.333736 -3346 706 4 0 9.969634 -13.724445 12.959529 -3347 706 4 0 9.789000 -15.194125 12.559782 -3348 707 6 0 2.391061 -15.016416 -4.564378 -3349 707 4 0 2.249440 -15.150315 -3.614545 -3350 707 4 0 3.332088 -14.950210 -4.710721 -3351 708 6 0 -21.651564 17.273027 -5.114431 -3352 708 4 0 -22.612266 17.402180 -4.967856 -3353 708 4 0 -21.475301 17.110688 -6.035544 -3354 709 6 0 10.670434 18.798919 9.295678 -3355 709 4 0 10.772878 18.810256 8.313948 -3356 709 4 0 10.935580 19.678994 9.619801 -3357 710 6 0 8.580286 -14.501479 3.135425 -3358 710 4 0 8.621343 -14.445805 4.107721 -3359 710 4 0 8.542982 -15.491097 3.062040 -3360 711 6 0 -14.377865 -7.995183 14.343301 -3361 711 4 0 -14.100201 -8.614257 14.993234 -3362 711 4 0 -14.866324 -7.355345 14.871637 -3363 712 6 0 -0.977425 16.774193 13.640180 -3364 712 4 0 -0.958949 17.266593 12.835191 -3365 712 4 0 -1.881684 16.955536 13.931092 -3366 713 6 0 -15.828708 -3.415349 7.406744 -3367 713 4 0 -16.180618 -3.426100 6.520488 -3368 713 4 0 -16.669651 -3.380771 7.995037 -3369 714 6 0 -12.774799 -8.235123 -12.889327 -3370 714 4 0 -12.978669 -7.282136 -13.083792 -3371 714 4 0 -13.615071 -8.678664 -13.235742 -3372 715 6 0 2.845289 0.060180 20.134181 -3373 715 4 0 2.858756 0.453048 19.232311 -3374 715 4 0 1.957136 -0.331348 20.300492 -3375 716 6 0 24.984643 -14.973253 -17.474954 -3376 716 4 0 25.370717 -15.847238 -17.382478 -3377 716 4 0 25.194569 -14.524794 -16.625306 -3378 717 6 0 13.620247 -7.920957 7.008348 -3379 717 4 0 14.470702 -8.278296 6.767655 -3380 717 4 0 13.126236 -7.674429 6.169358 -3381 718 6 0 17.636081 -10.073874 3.386982 -3382 718 4 0 17.376472 -9.849973 2.460148 -3383 718 4 0 17.541385 -10.988029 3.459151 -3384 719 6 0 -23.876026 -12.063687 -5.995846 -3385 719 4 0 -24.585420 -12.252172 -5.420831 -3386 719 4 0 -23.110219 -12.523733 -5.650434 -3387 720 6 0 -23.535607 1.699271 1.932031 -3388 720 4 0 -24.143027 1.031548 1.814474 -3389 720 4 0 -23.866587 2.338510 2.606284 -3390 721 6 0 13.720565 9.351789 12.307976 -3391 721 4 0 13.899370 10.225405 12.040604 -3392 721 4 0 13.192298 9.477241 13.121209 -3393 722 6 0 15.291476 15.170550 12.140656 -3394 722 4 0 14.287956 15.135496 12.069067 -3395 722 4 0 15.572140 14.570493 11.432982 -3396 723 6 0 -10.060226 -11.465180 13.094454 -3397 723 4 0 -9.757397 -11.240849 13.961157 -3398 723 4 0 -9.428065 -11.417927 12.436211 -3399 724 6 0 -19.840622 -4.281655 -17.053557 -3400 724 4 0 -20.444679 -3.559033 -16.740868 -3401 724 4 0 -20.093102 -5.062268 -16.449961 -3402 725 6 0 -11.088232 19.299933 12.989268 -3403 725 4 0 -11.278861 18.327556 12.943710 -3404 725 4 0 -10.555994 19.370336 13.806383 -3405 726 6 0 14.192836 -14.527612 16.897429 -3406 726 4 0 13.394071 -15.012895 17.049022 -3407 726 4 0 14.074952 -14.064189 16.039244 -3408 727 6 0 5.078670 -4.434084 15.727807 -3409 727 4 0 5.834022 -4.419315 16.349614 -3410 727 4 0 5.405954 -4.558925 14.872493 -3411 728 6 0 -19.510762 -4.936357 -8.682052 -3412 728 4 0 -18.583830 -4.871299 -8.739257 -3413 728 4 0 -19.725350 -4.373920 -7.917441 -3414 729 6 0 6.637127 -10.197837 -8.914867 -3415 729 4 0 7.303561 -10.846941 -9.129195 -3416 729 4 0 7.018008 -9.736820 -8.200293 -3417 730 6 0 -23.721355 20.227172 -16.438294 -3418 730 4 0 -24.533045 20.118818 -15.892499 -3419 730 4 0 -24.022901 20.350741 -17.335304 -3420 731 6 0 -0.030599 -15.820284 7.354097 -3421 731 4 0 -0.675125 -15.374015 6.761895 -3422 731 4 0 -0.583629 -16.217933 8.065590 -3423 732 6 0 17.878609 -6.751885 -17.518842 -3424 732 4 0 17.903391 -7.334049 -16.742820 -3425 732 4 0 17.140042 -7.214968 -18.038372 -3426 733 6 0 -5.849569 3.309930 19.753024 -3427 733 4 0 -6.252138 4.072448 20.161965 -3428 733 4 0 -5.149208 3.038493 20.337689 -3429 734 6 0 -24.710885 -6.308647 13.490216 -3430 734 4 0 -25.586238 -6.177846 13.106753 -3431 734 4 0 -24.889314 -6.461576 14.430169 -3432 735 6 0 -11.604329 -16.031249 -0.237137 -3433 735 4 0 -10.966421 -16.304157 -0.881127 -3434 735 4 0 -11.170811 -15.476610 0.378509 -3435 736 6 0 21.103321 -18.752766 6.405335 -3436 736 4 0 21.283349 -17.950114 6.943720 -3437 736 4 0 21.235391 -18.472219 5.506239 -3438 737 6 0 -0.369145 -20.712312 19.095306 -3439 737 4 0 0.355231 -20.367028 19.676247 -3440 737 4 0 -1.186977 -20.260183 19.421119 -3441 738 6 0 13.869578 -2.965624 18.758945 -3442 738 4 0 13.547281 -3.390529 19.570053 -3443 738 4 0 14.278344 -2.158860 19.065428 -3444 739 6 0 -15.806264 2.737988 -2.216704 -3445 739 4 0 -16.485177 2.180539 -1.805532 -3446 739 4 0 -15.814791 2.396599 -3.131246 -3447 740 6 0 -11.766416 -8.088239 8.837485 -3448 740 4 0 -11.812419 -8.926527 9.226533 -3449 740 4 0 -12.558194 -7.583042 9.186828 -3450 741 6 0 23.076788 16.678629 12.104295 -3451 741 4 0 23.468754 16.241536 11.310898 -3452 741 4 0 22.132874 16.713960 11.904816 -3453 742 6 0 -14.202464 -15.765503 -5.593495 -3454 742 4 0 -14.871838 -15.026911 -5.676361 -3455 742 4 0 -13.955401 -15.992753 -6.481500 -3456 743 6 0 15.150303 11.672770 19.298045 -3457 743 4 0 15.470730 12.261881 18.627217 -3458 743 4 0 15.518028 11.969931 20.141796 -3459 744 6 0 9.848503 -12.101587 -10.529245 -3460 744 4 0 10.607536 -11.738045 -10.041608 -3461 744 4 0 9.985842 -11.615457 -11.376399 -3462 745 6 0 2.125570 -11.875883 -16.645987 -3463 745 4 0 2.047554 -12.712083 -16.165814 -3464 745 4 0 2.067413 -12.170151 -17.579365 -3465 746 6 0 -5.977611 10.651495 7.046682 -3466 746 4 0 -5.213541 10.455986 7.620137 -3467 746 4 0 -6.494562 9.846985 7.169759 -3468 747 6 0 -16.351535 -7.485266 -9.424947 -3469 747 4 0 -16.745079 -6.668906 -9.070767 -3470 747 4 0 -16.602332 -8.158689 -8.798627 -3471 748 6 0 24.296678 -17.192464 4.785797 -3472 748 4 0 24.587865 -18.035334 5.123313 -3473 748 4 0 24.068802 -16.574501 5.523851 -3474 749 6 0 -10.968856 -18.323021 -8.138707 -3475 749 4 0 -11.363544 -18.853138 -8.863013 -3476 749 4 0 -10.206142 -17.988660 -8.562061 -3477 750 6 0 -9.854962 -9.956148 -15.278228 -3478 750 4 0 -10.293465 -9.897483 -14.451993 -3479 750 4 0 -9.970473 -10.887047 -15.573043 -3480 751 6 0 -2.935483 6.363032 -19.045018 -3481 751 4 0 -3.535132 5.588364 -18.854687 -3482 751 4 0 -3.494550 7.145960 -19.014910 -3483 752 6 0 5.112400 17.701587 -11.443651 -3484 752 4 0 5.575170 17.705031 -12.266361 -3485 752 4 0 5.677404 18.265335 -10.960537 -3486 753 6 0 -6.450118 17.009140 6.526693 -3487 753 4 0 -6.743394 16.108032 6.566324 -3488 753 4 0 -5.677664 17.076672 5.879731 -3489 754 6 0 13.801680 -10.581422 -18.444834 -3490 754 4 0 14.024633 -10.709852 -17.519503 -3491 754 4 0 14.526918 -10.713699 -19.015218 -3492 755 6 0 -26.491618 -8.486894 -15.884962 -3493 755 4 0 -26.227094 -9.167912 -16.481603 -3494 755 4 0 -27.254427 -8.747438 -15.427464 -3495 756 6 0 9.041006 -18.956744 11.010081 -3496 756 4 0 9.242427 -19.133960 10.087876 -3497 756 4 0 9.841718 -19.136012 11.534074 -3498 757 6 0 -14.427557 4.070601 -15.330760 -3499 757 4 0 -14.952347 4.033207 -14.554014 -3500 757 4 0 -14.812926 4.741427 -15.800456 -3501 758 6 0 17.060580 -3.941095 -20.977244 -3502 758 4 0 17.749250 -4.204310 -20.329442 -3503 758 4 0 16.300042 -3.942896 -20.427486 -3504 759 6 0 -23.014194 6.362529 14.192538 -3505 759 4 0 -23.324814 5.470443 14.451595 -3506 759 4 0 -22.082482 6.279068 14.241974 -3507 760 6 0 -25.628726 -6.961569 -2.257843 -3508 760 4 0 -25.574604 -7.184504 -1.341207 -3509 760 4 0 -26.582064 -6.786831 -2.353726 -3510 761 6 0 22.564240 2.932310 -9.807597 -3511 761 4 0 23.151969 3.604785 -10.163343 -3512 761 4 0 22.874635 2.102350 -10.219491 -3513 762 6 0 -3.253479 19.088800 -17.106412 -3514 762 4 0 -2.788864 19.318234 -16.243589 -3515 762 4 0 -2.764381 19.537649 -17.806531 -3516 763 6 0 -22.859061 13.661040 -17.687912 -3517 763 4 0 -22.818174 13.783386 -16.772102 -3518 763 4 0 -23.770832 13.543351 -17.918472 -3519 764 6 0 9.494782 -11.734449 -13.112549 -3520 764 4 0 8.961400 -12.465267 -13.446468 -3521 764 4 0 9.761388 -11.207603 -13.875868 -3522 765 6 0 -23.688259 3.132799 -17.827915 -3523 765 4 0 -24.125760 3.978960 -17.963214 -3524 765 4 0 -22.830341 3.138251 -18.271402 -3525 766 6 0 2.139153 19.832776 -5.462308 -3526 766 4 0 3.092901 19.927439 -5.794969 -3527 766 4 0 1.766619 18.977669 -5.658347 -3528 767 6 0 -18.034230 16.770127 14.099225 -3529 767 4 0 -17.902225 17.120236 14.993829 -3530 767 4 0 -17.676323 15.854045 14.106616 -3531 768 6 0 1.824513 11.181132 6.084313 -3532 768 4 0 1.685221 10.344866 6.529341 -3533 768 4 0 1.455718 11.848001 6.661967 -3534 769 6 0 -11.843291 -5.056449 -16.641604 -3535 769 4 0 -12.501020 -5.242103 -17.328702 -3536 769 4 0 -12.014281 -5.753377 -15.968200 -3537 770 6 0 -22.854164 5.542584 7.008128 -3538 770 4 0 -23.145262 4.706955 7.372586 -3539 770 4 0 -23.371620 6.215233 7.454255 -3540 771 6 0 15.073774 -20.411976 -0.392431 -3541 771 4 0 14.408322 -20.469017 0.286083 -3542 771 4 0 14.632572 -19.889979 -1.049199 -3543 772 6 0 -17.960070 -5.852749 5.689988 -3544 772 4 0 -18.090795 -5.039390 5.186397 -3545 772 4 0 -18.353234 -5.775538 6.579834 -3546 773 6 0 -15.352248 -19.036717 0.344261 -3547 773 4 0 -15.093308 -18.197320 -0.050384 -3548 773 4 0 -15.225898 -18.950231 1.302869 -3549 774 6 0 18.470960 -18.740483 5.244443 -3550 774 4 0 18.242618 -17.821184 5.079689 -3551 774 4 0 19.343394 -18.632602 5.657266 -3552 775 6 0 -20.494949 -15.508798 0.415196 -3553 775 4 0 -21.033257 -14.800381 0.873351 -3554 775 4 0 -20.631551 -16.381502 0.919462 -3555 776 6 0 -26.836213 -15.820962 -1.291434 -3556 776 4 0 -25.922353 -15.963173 -1.047747 -3557 776 4 0 -27.438259 -16.224400 -0.574562 -3558 777 6 0 -13.235942 4.403119 -11.675233 -3559 777 4 0 -12.394934 3.955397 -11.762629 -3560 777 4 0 -13.370313 4.660640 -10.729304 -3561 778 6 0 4.457457 8.304220 -12.786971 -3562 778 4 0 3.724242 8.788507 -13.141101 -3563 778 4 0 4.902410 9.007385 -12.278991 -3564 779 6 0 12.905103 9.611740 -9.761522 -3565 779 4 0 12.523788 8.903277 -10.260068 -3566 779 4 0 13.450668 9.299611 -9.028515 -3567 780 6 0 -6.337643 16.236433 1.452793 -3568 780 4 0 -5.424381 16.339480 1.573225 -3569 780 4 0 -6.667968 16.644895 2.291271 -3570 781 6 0 26.439116 -1.915810 -20.713552 -3571 781 4 0 27.188632 -1.287536 -20.817388 -3572 781 4 0 26.782485 -2.730706 -20.995261 -3573 782 6 0 -19.182622 4.092355 9.034920 -3574 782 4 0 -19.485362 4.670885 8.308243 -3575 782 4 0 -20.013187 3.814515 9.521856 -3576 783 6 0 -2.300541 3.557512 -14.043398 -3577 783 4 0 -1.431422 3.599599 -13.555115 -3578 783 4 0 -1.988145 3.224630 -14.961052 -3579 784 6 0 -6.670819 -15.218721 -14.514642 -3580 784 4 0 -6.017795 -15.980959 -14.424699 -3581 784 4 0 -6.265671 -14.423752 -14.172913 -3582 785 6 0 24.507006 4.960415 18.725868 -3583 785 4 0 24.051892 4.202462 19.172938 -3584 785 4 0 23.940639 5.744203 18.851669 -3585 786 6 0 24.049293 12.473043 -13.141226 -3586 786 4 0 23.243912 12.962673 -12.967339 -3587 786 4 0 23.840443 11.608716 -13.489633 -3588 787 6 0 -14.826342 -14.174711 -1.101280 -3589 787 4 0 -14.425942 -14.926791 -0.673989 -3590 787 4 0 -15.768151 -14.488595 -1.118329 -3591 788 6 0 11.933486 13.553808 -14.961215 -3592 788 4 0 11.036396 13.817670 -14.752407 -3593 788 4 0 12.216429 12.950104 -14.279104 -3594 789 6 0 -2.797562 -12.367574 -0.515800 -3595 789 4 0 -3.179634 -11.713519 0.050158 -3596 789 4 0 -1.854871 -12.532942 -0.270880 -3597 790 6 0 17.488207 19.028545 -2.724709 -3598 790 4 0 17.501182 19.646316 -1.945319 -3599 790 4 0 17.260989 19.579570 -3.517708 -3600 791 6 0 -8.757369 -14.229883 -8.206010 -3601 791 4 0 -8.893000 -13.537739 -8.862015 -3602 791 4 0 -9.392123 -14.135387 -7.486682 -3603 792 6 0 -19.153579 -12.365172 5.625409 -3604 792 4 0 -19.433383 -12.590110 4.725475 -3605 792 4 0 -19.595557 -11.555979 5.869535 -3606 793 6 0 -7.701926 -16.135625 -11.737971 -3607 793 4 0 -6.868196 -16.044745 -12.240387 -3608 793 4 0 -8.301809 -15.535544 -12.265120 -3609 794 6 0 -3.605808 12.358960 20.023921 -3610 794 4 0 -4.119307 12.832959 19.358309 -3611 794 4 0 -4.145218 11.656406 20.372183 -3612 795 6 0 -13.013980 18.377636 -12.951904 -3613 795 4 0 -12.288179 17.997337 -13.504982 -3614 795 4 0 -12.538318 18.992103 -12.385350 -3615 796 6 0 -1.385735 6.480272 7.505236 -3616 796 4 0 -1.829939 5.594981 7.333987 -3617 796 4 0 -1.326794 6.575998 8.446333 -3618 797 6 0 9.907861 10.609361 -15.151767 -3619 797 4 0 10.299023 10.375476 -14.276851 -3620 797 4 0 9.651161 11.529891 -14.985274 -3621 798 6 0 9.310538 -2.514250 -12.134416 -3622 798 4 0 10.198177 -2.553660 -11.653872 -3623 798 4 0 8.836792 -1.753472 -11.726830 -3624 799 6 0 -21.580142 4.778390 0.032360 -3625 799 4 0 -21.344591 5.531473 -0.492439 -3626 799 4 0 -20.893065 4.098475 -0.015753 -3627 800 6 0 -19.278441 10.667329 -7.670184 -3628 800 4 0 -19.734646 10.867025 -6.871193 -3629 800 4 0 -18.532328 10.061861 -7.412248 -3630 801 6 0 15.203902 17.401580 19.186703 -3631 801 4 0 15.570898 16.998223 18.309293 -3632 801 4 0 14.252264 17.471997 19.020983 -3633 802 6 0 17.475659 -4.241820 15.422666 -3634 802 4 0 17.040898 -4.071975 16.320909 -3635 802 4 0 18.352897 -4.517345 15.720235 -3636 803 6 0 26.262986 8.204965 -20.205701 -3637 803 4 0 26.293506 8.464866 -19.242230 -3638 803 4 0 25.312183 8.095575 -20.318886 -3639 804 6 0 0.327844 9.896832 15.417356 -3640 804 4 0 1.202524 9.685899 15.170065 -3641 804 4 0 -0.168717 9.349803 14.747140 -3642 805 6 0 13.450972 -1.248355 9.296159 -3643 805 4 0 12.530981 -1.651940 9.252801 -3644 805 4 0 13.953341 -1.912001 9.787602 -3645 806 6 0 -5.429467 -15.995612 -8.899753 -3646 806 4 0 -4.916725 -16.325409 -8.062672 -3647 806 4 0 -6.362549 -16.264748 -8.759990 -3648 807 6 0 -17.910357 -1.868084 -15.474085 -3649 807 4 0 -18.801800 -2.365773 -15.300107 -3650 807 4 0 -17.939036 -0.883951 -15.233581 -3651 808 6 0 -6.998449 17.854546 12.155260 -3652 808 4 0 -7.324766 18.684261 11.705842 -3653 808 4 0 -7.250338 17.940958 13.056006 -3654 809 6 0 -27.017579 -12.852914 -7.744953 -3655 809 4 0 -26.095216 -13.088941 -7.541719 -3656 809 4 0 -27.046015 -11.903607 -7.742366 -3657 810 6 0 -20.992952 2.770137 13.223137 -3658 810 4 0 -21.230776 2.404263 14.087077 -3659 810 4 0 -20.235470 2.326081 12.930982 -3660 811 6 0 -26.544599 -5.877011 11.453664 -3661 811 4 0 -26.990332 -6.544246 10.916058 -3662 811 4 0 -26.022394 -5.435999 10.830265 -3663 812 6 0 -18.806379 11.367507 -13.046200 -3664 812 4 0 -19.789015 11.313553 -13.067429 -3665 812 4 0 -18.628129 11.249318 -14.024506 -3666 813 6 0 24.794642 -2.429791 16.906929 -3667 813 4 0 24.375084 -1.564983 16.998802 -3668 813 4 0 24.946627 -2.558178 15.958491 -3669 814 6 0 -5.039569 8.056593 -19.064906 -3670 814 4 0 -5.052461 7.958795 -18.117466 -3671 814 4 0 -5.966890 7.849304 -19.446709 -3672 815 6 0 -2.889572 19.346856 10.223639 -3673 815 4 0 -3.384312 19.390763 9.401856 -3674 815 4 0 -2.683383 20.308050 10.287170 -3675 816 6 0 24.834396 15.890694 6.130456 -3676 816 4 0 24.234322 16.328808 6.788069 -3677 816 4 0 24.458399 16.070054 5.248361 -3678 817 6 0 -5.675815 -18.202610 8.635402 -3679 817 4 0 -5.773224 -18.994730 9.253066 -3680 817 4 0 -6.566693 -17.951332 8.462469 -3681 818 6 0 0.200228 10.638735 -9.720146 -3682 818 4 0 1.124053 10.363079 -9.765946 -3683 818 4 0 -0.169388 10.758518 -8.862327 -3684 819 6 0 12.586551 -8.995486 13.235948 -3685 819 4 0 11.738414 -8.465169 13.179917 -3686 819 4 0 13.275714 -8.448558 12.911108 -3687 820 6 0 21.728995 -9.340509 14.117203 -3688 820 4 0 21.166035 -8.543859 14.159733 -3689 820 4 0 21.300249 -10.103143 14.587027 -3690 821 6 0 -6.837755 -7.061822 -14.579566 -3691 821 4 0 -7.451539 -6.737549 -13.910594 -3692 821 4 0 -7.310401 -7.496795 -15.364575 -3693 822 6 0 -9.354286 -10.670675 -5.815047 -3694 822 4 0 -9.142443 -9.961054 -6.416990 -3695 822 4 0 -10.107132 -10.315463 -5.251791 -3696 823 6 0 -8.705352 0.316369 14.356920 -3697 823 4 0 -8.755318 1.248673 14.182151 -3698 823 4 0 -7.817961 -0.022395 14.313721 -3699 824 6 0 14.343736 18.982116 -1.699643 -3700 824 4 0 14.409424 19.286931 -2.586247 -3701 824 4 0 14.592964 19.709765 -1.190359 -3702 825 6 0 14.559527 1.138316 10.218417 -3703 825 4 0 15.479051 1.159830 9.856479 -3704 825 4 0 14.063855 0.416501 9.816078 -3705 826 6 0 -20.566241 -0.996254 13.005878 -3706 826 4 0 -20.899331 -1.479928 12.209922 -3707 826 4 0 -20.624473 -1.700653 13.673656 -3708 827 6 0 -12.852778 -16.278261 -7.915385 -3709 827 4 0 -13.264438 -16.542888 -8.750067 -3710 827 4 0 -12.112512 -16.948829 -7.782415 -3711 828 6 0 -25.785944 -19.319619 -1.839096 -3712 828 4 0 -26.458799 -18.855500 -2.342721 -3713 828 4 0 -25.985807 -19.145409 -0.929325 -3714 829 6 0 -10.186107 18.619821 1.502896 -3715 829 4 0 -10.024101 19.020438 2.390188 -3716 829 4 0 -10.942245 19.107400 1.164289 -3717 830 6 0 4.484858 10.819107 -17.964431 -3718 830 4 0 5.133939 11.386899 -18.298672 -3719 830 4 0 4.527691 10.727124 -17.013873 -3720 831 6 0 6.463933 -18.890881 -12.906574 -3721 831 4 0 7.142489 -18.893949 -12.181472 -3722 831 4 0 6.490763 -19.813219 -13.109192 -3723 832 6 0 -15.198788 -16.766626 -9.336110 -3724 832 4 0 -15.377180 -16.563167 -8.461513 -3725 832 4 0 -15.323254 -15.974257 -9.877497 -3726 833 6 0 -14.146010 -20.422548 8.878122 -3727 833 4 0 -14.236979 -20.532175 7.917793 -3728 833 4 0 -13.662828 -21.215449 9.131232 -3729 834 6 0 0.614957 1.428020 12.956126 -3730 834 4 0 -0.110540 1.901658 12.528670 -3731 834 4 0 0.325279 0.716474 13.497208 -3732 835 6 0 -22.321257 -12.194484 -18.427855 -3733 835 4 0 -22.696325 -13.106322 -18.375252 -3734 835 4 0 -22.412389 -11.917225 -19.335761 -3735 836 6 0 12.531442 -4.758462 20.472899 -3736 836 4 0 13.067534 -4.753926 21.307738 -3737 836 4 0 12.096556 -5.562360 20.454035 -3738 837 6 0 13.892356 14.515119 -17.220006 -3739 837 4 0 13.491013 15.249793 -17.676248 -3740 837 4 0 14.027899 14.819402 -16.306112 -3741 838 6 0 17.502120 -14.847049 -15.435947 -3742 838 4 0 17.364472 -13.948352 -15.811879 -3743 838 4 0 18.105027 -15.359005 -16.059699 -3744 839 6 0 -0.502268 9.530205 -15.562269 -3745 839 4 0 -0.938753 10.373293 -15.281955 -3746 839 4 0 -0.097702 9.138998 -14.755615 -3747 840 6 0 -21.309309 -20.408905 -16.987522 -3748 840 4 0 -21.345337 -20.375840 -17.999142 -3749 840 4 0 -22.141862 -20.762308 -16.688786 -3750 841 6 0 22.147493 -6.639909 2.885000 -3751 841 4 0 22.188652 -7.549798 2.578098 -3752 841 4 0 22.107229 -6.728348 3.871637 -3753 842 6 0 -9.687279 5.414380 15.613331 -3754 842 4 0 -9.782742 5.066486 16.529208 -3755 842 4 0 -10.448969 5.923644 15.361474 -3756 843 6 0 5.675344 7.586899 16.980957 -3757 843 4 0 5.258959 7.810456 16.122506 -3758 843 4 0 6.513311 8.070410 16.991766 -3759 844 6 0 -20.413973 -2.810756 -14.704675 -3760 844 4 0 -20.680710 -3.455276 -14.087899 -3761 844 4 0 -20.927913 -2.006038 -14.605374 -3762 845 6 0 -22.235897 -8.299273 -7.619662 -3763 845 4 0 -22.889194 -7.882281 -8.261122 -3764 845 4 0 -22.332627 -7.861076 -6.765324 -3765 846 6 0 -23.981218 -0.704780 -9.514827 -3766 846 4 0 -24.783483 -0.715849 -8.978342 -3767 846 4 0 -24.016239 0.147898 -9.927153 -3768 847 6 0 7.651613 1.583143 -14.760840 -3769 847 4 0 8.495812 1.439050 -15.299970 -3770 847 4 0 7.511620 2.516131 -14.862425 -3771 848 6 0 0.884173 -19.810112 -4.062624 -3772 848 4 0 1.292889 -20.586437 -4.551786 -3773 848 4 0 1.192078 -19.022801 -4.536111 -3774 849 6 0 7.412040 11.115702 19.231433 -3775 849 4 0 7.538580 12.059258 19.246795 -3776 849 4 0 8.260401 10.691591 19.301522 -3777 850 6 0 -11.204219 12.495567 -4.600276 -3778 850 4 0 -11.028750 12.509428 -5.556334 -3779 850 4 0 -10.363635 12.791820 -4.218009 -3780 851 6 0 -25.903206 -8.385161 -5.723268 -3781 851 4 0 -25.119970 -7.920015 -6.092411 -3782 851 4 0 -25.526651 -8.874179 -5.022568 -3783 852 6 0 14.802024 4.590987 3.933454 -3784 852 4 0 14.375737 4.043905 3.277970 -3785 852 4 0 15.659394 4.916121 3.578549 -3786 853 6 0 -15.934931 6.397950 6.388644 -3787 853 4 0 -15.620802 7.216906 6.047813 -3788 853 4 0 -15.636175 5.690485 5.842853 -3789 854 6 0 22.212269 -3.912264 -1.134049 -3790 854 4 0 22.458591 -3.040474 -1.407870 -3791 854 4 0 22.479085 -3.998208 -0.233468 -3792 855 6 0 4.448770 -18.623307 6.143091 -3793 855 4 0 3.859811 -18.031485 6.593889 -3794 855 4 0 4.151476 -19.464236 6.536017 -3795 856 6 0 12.429816 -18.121512 9.248186 -3796 856 4 0 11.629942 -18.388099 8.814270 -3797 856 4 0 12.215561 -17.727680 10.120763 -3798 857 6 0 -8.497823 15.258872 16.966673 -3799 857 4 0 -7.810852 14.986731 16.348784 -3800 857 4 0 -8.167882 16.114306 17.249722 -3801 858 6 0 -20.878291 -14.745638 19.779655 -3802 858 4 0 -20.112590 -15.386225 19.796245 -3803 858 4 0 -20.957585 -14.429386 20.699068 -3804 859 6 0 -8.042069 13.212107 -6.799126 -3805 859 4 0 -7.666844 14.065367 -7.020588 -3806 859 4 0 -8.432360 12.994260 -7.617112 -3807 860 6 0 -4.401745 18.792233 12.536049 -3808 860 4 0 -5.252264 18.441661 12.206342 -3809 860 4 0 -3.786314 18.658531 11.783750 -3810 861 6 0 -22.502948 12.635671 -9.954592 -3811 861 4 0 -22.382976 11.654218 -10.023557 -3812 861 4 0 -22.588936 12.849370 -9.051340 -3813 862 6 0 6.205019 19.677761 10.016183 -3814 862 4 0 6.418256 20.244108 9.256973 -3815 862 4 0 6.081289 20.311217 10.773751 -3816 863 6 0 21.525435 -20.385383 2.444412 -3817 863 4 0 21.737318 -20.408572 1.494251 -3818 863 4 0 22.084053 -21.109629 2.761837 -3819 864 6 0 -16.599942 -18.820535 17.198669 -3820 864 4 0 -16.278472 -18.736077 16.290240 -3821 864 4 0 -16.380933 -19.763878 17.294110 -3822 865 6 0 -25.290808 -16.946358 -19.688799 -3823 865 4 0 -24.765600 -16.889073 -18.911085 -3824 865 4 0 -25.960541 -16.377910 -19.456590 -3825 866 6 0 -24.694098 -20.476906 -4.136770 -3826 866 4 0 -24.606655 -20.536372 -5.117234 -3827 866 4 0 -25.625806 -20.119370 -3.878957 -3828 867 6 0 11.896824 11.712030 16.306177 -3829 867 4 0 11.348704 12.251154 16.873688 -3830 867 4 0 11.274914 11.545841 15.498058 -3831 868 6 0 5.697623 16.972820 10.470297 -3832 868 4 0 4.991770 17.170798 11.097893 -3833 868 4 0 5.852878 17.817924 10.052784 -3834 869 6 0 -13.284850 -7.746454 -6.025360 -3835 869 4 0 -12.994189 -6.883337 -5.651840 -3836 869 4 0 -13.328473 -7.609512 -6.952585 -3837 870 6 0 -21.223162 1.160412 -11.807882 -3838 870 4 0 -22.146291 1.276713 -11.566889 -3839 870 4 0 -20.896068 1.043394 -10.863664 -3840 871 6 0 -4.631057 18.622729 -4.921244 -3841 871 4 0 -4.887844 18.863646 -4.031199 -3842 871 4 0 -5.230286 17.969756 -5.219284 -3843 872 6 0 24.681797 -17.654294 -1.670971 -3844 872 4 0 23.768274 -17.475294 -1.329114 -3845 872 4 0 24.791039 -18.602540 -1.565321 -3846 873 6 0 -17.687536 -19.879421 -18.679576 -3847 873 4 0 -17.986562 -20.092647 -17.773622 -3848 873 4 0 -17.222303 -20.676328 -18.924760 -3849 874 6 0 -6.573668 -1.414933 -12.940464 -3850 874 4 0 -5.981594 -0.685726 -13.202528 -3851 874 4 0 -7.313339 -1.430989 -13.600227 -3852 875 6 0 24.852405 8.745112 16.566019 -3853 875 4 0 25.315387 9.320408 17.189845 -3854 875 4 0 25.373490 7.938156 16.494188 -3855 876 6 0 19.231159 -18.894566 -9.451949 -3856 876 4 0 18.429507 -18.461081 -9.748217 -3857 876 4 0 18.920766 -19.499725 -8.784679 -3858 877 6 0 3.338073 -20.229490 -19.454945 -3859 877 4 0 2.656040 -19.781393 -18.876483 -3860 877 4 0 4.028693 -19.592026 -19.519704 -3861 878 6 0 10.225819 20.337141 12.829025 -3862 878 4 0 9.563839 20.833795 13.325284 -3863 878 4 0 9.705679 19.640109 12.367009 -3864 879 6 0 9.533934 0.668964 -16.571520 -3865 879 4 0 10.399193 0.538209 -16.091711 -3866 879 4 0 9.576351 1.385138 -17.298275 -3867 880 6 0 10.662383 -1.197996 9.643694 -3868 880 4 0 10.669217 -0.519470 10.302977 -3869 880 4 0 9.975986 -0.906856 8.995989 -3870 881 6 0 -8.631045 -16.685206 -9.233119 -3871 881 4 0 -8.853335 -15.836492 -8.694578 -3872 881 4 0 -8.361803 -16.344073 -10.088388 -3873 882 6 0 -16.046867 3.202795 -18.808362 -3874 882 4 0 -16.950450 3.324347 -19.009457 -3875 882 4 0 -16.106623 2.648826 -18.004784 -3876 883 6 0 -21.655953 -18.268305 -5.022876 -3877 883 4 0 -22.220521 -18.292491 -4.188932 -3878 883 4 0 -21.437192 -17.347868 -5.235461 -3879 884 6 0 -3.054479 -8.582825 -16.474970 -3880 884 4 0 -3.561388 -8.760643 -15.715699 -3881 884 4 0 -3.058659 -7.559442 -16.547327 -3882 885 6 0 -22.812267 -16.888527 -8.744475 -3883 885 4 0 -22.235942 -16.090582 -8.825879 -3884 885 4 0 -23.719738 -16.520887 -8.878128 -3885 886 6 0 -3.704190 -14.195133 -2.407699 -3886 886 4 0 -3.387102 -14.174810 -3.288821 -3887 886 4 0 -3.356349 -13.453995 -1.933962 -3888 887 6 0 -20.696165 -13.591009 17.258237 -3889 887 4 0 -21.475297 -13.153296 16.960866 -3890 887 4 0 -20.768473 -13.524910 18.211894 -3891 888 6 0 -18.077515 8.036142 -4.047377 -3892 888 4 0 -17.812789 8.648744 -4.737838 -3893 888 4 0 -17.620887 8.520879 -3.289746 -3894 889 6 0 -20.110600 19.407267 6.124785 -3895 889 4 0 -20.896902 18.868688 6.157232 -3896 889 4 0 -20.402600 20.334320 6.077069 -3897 890 6 0 -2.051195 9.467924 7.827905 -3898 890 4 0 -2.097838 10.162479 7.064246 -3899 890 4 0 -2.844983 9.344092 8.305687 -3900 891 6 0 -18.682154 5.478699 -2.934427 -3901 891 4 0 -18.229636 5.442492 -2.124369 -3902 891 4 0 -18.518659 6.286464 -3.381696 -3903 892 6 0 10.010203 14.447632 13.470001 -3904 892 4 0 10.226696 15.357421 13.799091 -3905 892 4 0 9.262668 14.599091 12.884669 -3906 893 6 0 17.215836 -17.548329 -2.124086 -3907 893 4 0 16.925189 -16.662250 -2.252230 -3908 893 4 0 16.865887 -17.769074 -1.235796 -3909 894 6 0 -5.919183 -9.349524 7.766171 -3910 894 4 0 -6.741218 -8.869400 7.859192 -3911 894 4 0 -5.404573 -8.951408 7.082536 -3912 895 6 0 -10.112774 -17.514245 5.470012 -3913 895 4 0 -10.177248 -17.335797 6.413035 -3914 895 4 0 -10.903396 -17.912916 5.176788 -3915 896 6 0 -17.679442 -12.718669 -9.050443 -3916 896 4 0 -18.270476 -12.557016 -8.300034 -3917 896 4 0 -18.198469 -12.552825 -9.805697 -3918 897 6 0 0.903259 -17.089060 -20.671596 -3919 897 4 0 1.071535 -16.725461 -21.579419 -3920 897 4 0 1.485989 -16.556142 -20.071022 -3921 898 6 0 -1.956506 2.203046 13.006137 -3922 898 4 0 -2.272231 1.835920 13.818085 -3923 898 4 0 -1.592679 3.074581 13.177858 -3924 899 6 0 24.307317 -7.931160 13.942533 -3925 899 4 0 23.816648 -8.756525 14.130421 -3926 899 4 0 25.262169 -8.082231 14.204005 -3927 900 6 0 -14.058968 19.300765 0.314297 -3928 900 4 0 -13.917031 18.387642 0.266006 -3929 900 4 0 -13.221511 19.754514 0.415523 -3930 901 6 0 -16.676872 -9.877858 -20.319129 -3931 901 4 0 -17.274810 -10.519927 -20.729021 -3932 901 4 0 -16.941519 -8.964879 -20.646570 -3933 902 6 0 -12.680702 -6.911233 16.978199 -3934 902 4 0 -13.557850 -6.922758 17.425905 -3935 902 4 0 -12.269134 -7.738029 17.145620 -3936 903 6 0 19.555509 -17.579926 -19.976313 -3937 903 4 0 19.050335 -18.389167 -19.640518 -3938 903 4 0 18.949443 -17.119931 -20.527020 -3939 904 6 0 21.076471 3.084534 14.949703 -3940 904 4 0 21.982711 3.424585 15.137726 -3941 904 4 0 21.059338 2.943234 13.989445 -3942 905 6 0 16.442213 12.147725 -13.378964 -3943 905 4 0 16.950297 12.610197 -12.695317 -3944 905 4 0 15.827762 12.795203 -13.746701 -3945 906 6 0 -25.439902 4.711302 -20.157995 -3946 906 4 0 -25.232468 3.814757 -20.523590 -3947 906 4 0 -26.313293 4.971364 -20.426324 -3948 907 6 0 -7.588528 12.088664 13.408162 -3949 907 4 0 -8.200423 12.174754 12.658025 -3950 907 4 0 -8.113691 11.630720 14.142990 -3951 908 6 0 26.436785 0.034911 5.586573 -3952 908 4 0 25.457878 0.386547 5.643112 -3953 908 4 0 26.282513 -0.892272 5.901143 -3954 909 6 0 20.823937 -7.100912 -0.564869 -3955 909 4 0 20.884805 -6.179294 -0.203608 -3956 909 4 0 21.513466 -7.607628 -0.095760 -3957 910 6 0 12.691400 17.480587 1.380786 -3958 910 4 0 12.692396 17.261428 2.322353 -3959 910 4 0 12.611923 16.651984 0.923905 -3960 911 6 0 -24.911725 10.197954 8.411953 -3961 911 4 0 -25.636701 10.762551 8.096402 -3962 911 4 0 -25.071847 10.060147 9.332683 -3963 912 6 0 -18.639378 5.447813 -18.001661 -3964 912 4 0 -18.974361 6.320483 -18.277153 -3965 912 4 0 -17.987263 5.631149 -17.283273 -3966 913 6 0 -20.959865 -1.961151 19.496385 -3967 913 4 0 -20.534023 -2.468481 20.215248 -3968 913 4 0 -20.355179 -1.361709 19.053432 -3969 914 6 0 25.098062 -12.896695 17.002170 -3970 914 4 0 24.406639 -13.455503 17.206622 -3971 914 4 0 24.932322 -12.540708 16.110034 -3972 915 6 0 -26.490917 -20.588542 6.528398 -3973 915 4 0 -26.917008 -20.096913 5.823633 -3974 915 4 0 -25.946103 -19.813146 6.884354 -3975 916 6 0 18.663882 -15.761448 0.434559 -3976 916 4 0 18.293356 -16.602715 0.618971 -3977 916 4 0 18.164755 -15.050245 0.892557 -3978 917 6 0 10.988074 -12.207500 15.456319 -3979 917 4 0 11.659991 -12.535619 14.945024 -3980 917 4 0 11.316489 -11.864883 16.268157 -3981 918 6 0 -21.505805 3.757682 10.585783 -3982 918 4 0 -21.516645 3.500786 11.561155 -3983 918 4 0 -21.430683 4.736521 10.599986 -3984 919 6 0 12.282284 -13.106227 -18.881930 -3985 919 4 0 12.759593 -12.281589 -18.973554 -3986 919 4 0 11.656222 -12.946682 -18.168338 -3987 920 6 0 13.087944 10.285301 -0.892868 -3988 920 4 0 13.800763 10.058844 -0.348329 -3989 920 4 0 13.444993 10.532975 -1.717057 -3990 921 6 0 -9.162139 -11.933739 -19.558277 -3991 921 4 0 -8.651549 -11.246835 -19.197918 -3992 921 4 0 -8.816392 -12.749175 -19.109531 -3993 922 6 0 -13.431343 12.125781 14.789987 -3994 922 4 0 -14.177333 12.077783 15.386597 -3995 922 4 0 -13.089871 13.025037 14.836795 -3996 923 6 0 18.177368 7.215321 -17.740007 -3997 923 4 0 17.389540 7.853045 -17.679076 -3998 923 4 0 17.843221 6.367105 -17.888163 -3999 924 6 0 1.466167 -13.601298 7.582198 -4000 924 4 0 0.972435 -14.385853 7.776388 -4001 924 4 0 0.919057 -12.873156 7.164133 -4002 925 6 0 11.325663 12.317782 -17.859494 -4003 925 4 0 11.786996 12.918180 -17.243704 -4004 925 4 0 11.714407 11.538450 -17.534509 -4005 926 6 0 17.972713 -1.451543 -17.483151 -4006 926 4 0 18.207855 -0.912662 -18.203981 -4007 926 4 0 17.842338 -0.769611 -16.779012 -4008 927 6 0 25.598333 7.442585 -7.896359 -4009 927 4 0 25.893540 7.973241 -8.686847 -4010 927 4 0 24.662621 7.579298 -7.748832 -4011 928 6 0 16.953262 -5.516556 7.796955 -4012 928 4 0 16.150883 -6.127947 7.920888 -4013 928 4 0 16.872953 -4.676742 8.219748 -4014 929 6 0 12.447806 -2.742404 -5.103683 -4015 929 4 0 13.262065 -2.337192 -4.865615 -4016 929 4 0 12.567802 -3.638206 -5.489980 -4017 930 6 0 23.442824 1.912863 -4.186751 -4018 930 4 0 22.783687 1.609227 -4.831788 -4019 930 4 0 23.692291 2.783304 -4.548967 -4020 931 6 0 26.613065 -7.057291 -2.847144 -4021 931 4 0 25.921057 -6.884909 -2.189136 -4022 931 4 0 26.624480 -6.286981 -3.475448 -4023 932 6 0 -10.239445 -6.332791 -18.742073 -4024 932 4 0 -10.340169 -5.647767 -18.098924 -4025 932 4 0 -10.090969 -5.968696 -19.646250 -4026 933 6 0 -20.376403 -6.492157 -15.200035 -4027 933 4 0 -21.216096 -6.709010 -14.741818 -4028 933 4 0 -19.747585 -6.443291 -14.454302 -4029 934 6 0 12.425316 -12.073259 9.372568 -4030 934 4 0 12.595386 -11.730652 10.279050 -4031 934 4 0 11.975580 -11.375801 8.874658 -4032 935 6 0 -8.532199 -0.531892 16.952480 -4033 935 4 0 -8.680978 0.164546 17.584693 -4034 935 4 0 -8.601294 -0.093174 16.091071 -4035 936 6 0 -15.814683 -10.863297 -17.898155 -4036 936 4 0 -15.883461 -10.639190 -18.879894 -4037 936 4 0 -16.703278 -10.849248 -17.497731 -4038 937 6 0 -14.449801 9.759702 -12.925291 -4039 937 4 0 -14.272437 8.788361 -12.976539 -4040 937 4 0 -15.016657 9.891030 -12.180657 -4041 938 6 0 -21.430732 11.921106 -19.181002 -4042 938 4 0 -21.526880 12.138660 -20.109451 -4043 938 4 0 -22.050688 12.479567 -18.617821 -4044 939 6 0 -25.974066 -3.158098 2.462777 -4045 939 4 0 -25.831369 -2.255405 2.174801 -4046 939 4 0 -26.439926 -3.064742 3.263507 -4047 940 6 0 -3.706735 6.147388 -13.605663 -4048 940 4 0 -3.297323 5.307884 -13.886877 -4049 940 4 0 -3.422860 6.737980 -14.321183 -4050 941 6 0 -20.883597 16.612287 14.041958 -4051 941 4 0 -20.999564 17.543929 13.958831 -4052 941 4 0 -19.965627 16.487176 14.039107 -4053 942 6 0 -20.557889 -1.845471 7.488592 -4054 942 4 0 -20.340337 -1.068424 6.935483 -4055 942 4 0 -20.903185 -2.604394 7.012639 -4056 943 6 0 -12.460264 -18.929249 4.382660 -4057 943 4 0 -12.282133 -18.769615 3.435033 -4058 943 4 0 -13.389343 -18.666156 4.432821 -4059 944 6 0 1.417248 11.708889 10.582961 -4060 944 4 0 2.296023 11.794703 10.114913 -4061 944 4 0 1.322165 12.680869 10.895877 -4062 945 6 0 10.022181 17.152306 -1.509079 -4063 945 4 0 9.099220 16.788088 -1.473811 -4064 945 4 0 10.556572 16.462293 -1.005697 -4065 946 6 0 26.377298 1.167852 -18.114945 -4066 946 4 0 26.294922 1.597527 -19.017371 -4067 946 4 0 26.810582 1.835218 -17.546811 -4068 947 6 0 4.477282 16.231872 -2.892567 -4069 947 4 0 4.601255 15.878653 -3.817385 -4070 947 4 0 5.378487 16.115183 -2.438618 -4071 948 6 0 24.364511 -2.064551 14.086212 -4072 948 4 0 24.217903 -1.193238 13.665466 -4073 948 4 0 25.144037 -2.400521 13.646565 -4074 949 6 0 19.972396 19.003953 10.129446 -4075 949 4 0 19.099910 19.391464 10.278245 -4076 949 4 0 20.140306 18.289889 10.813702 -4077 950 6 0 -9.744468 15.055459 -16.611544 -4078 950 4 0 -10.467454 15.614656 -16.286228 -4079 950 4 0 -10.073803 14.402676 -17.210684 -4080 951 6 0 -7.338670 -8.956276 -11.936725 -4081 951 4 0 -7.205180 -9.461193 -11.112425 -4082 951 4 0 -8.291268 -8.840677 -12.000288 -4083 952 6 0 9.310332 14.156142 -6.279488 -4084 952 4 0 10.218649 13.951492 -6.545390 -4085 952 4 0 9.258047 14.553265 -5.370592 -4086 953 6 0 0.560208 -13.174622 -9.781962 -4087 953 4 0 0.439761 -12.748376 -10.646076 -4088 953 4 0 0.670280 -14.103731 -9.913873 -4089 954 6 0 26.128167 14.199294 -1.068870 -4090 954 4 0 26.431992 13.452397 -0.460937 -4091 954 4 0 25.201007 14.292566 -1.045597 -4092 955 6 0 -16.949107 1.727945 -4.563937 -4093 955 4 0 -16.652995 1.770027 -5.488123 -4094 955 4 0 -17.803051 2.243334 -4.537865 -4095 956 6 0 -11.599049 -20.904475 0.385428 -4096 956 4 0 -11.617180 -19.974350 0.739051 -4097 956 4 0 -10.733402 -20.802194 -0.016961 -4098 957 6 0 -25.256117 12.394753 17.084014 -4099 957 4 0 -24.597187 12.955531 17.523929 -4100 957 4 0 -25.351341 11.801006 17.816577 -4101 958 6 0 21.083077 10.997597 -6.264609 -4102 958 4 0 20.914438 11.935561 -6.410001 -4103 958 4 0 20.611065 10.573853 -6.944918 -4104 959 6 0 24.363484 -19.776402 17.065120 -4105 959 4 0 24.744693 -19.074320 16.551577 -4106 959 4 0 25.036878 -20.294208 17.436608 -4107 960 6 0 -10.735684 9.638082 6.150386 -4108 960 4 0 -10.221167 9.463561 5.360913 -4109 960 4 0 -11.618988 9.902798 5.921573 -4110 961 6 0 -14.186781 2.877388 6.286661 -4111 961 4 0 -14.662769 3.118087 7.092293 -4112 961 4 0 -14.425510 3.607015 5.695311 -4113 962 6 0 23.488790 -12.140879 -16.710373 -4114 962 4 0 23.035645 -11.840916 -17.492726 -4115 962 4 0 24.198140 -11.533887 -16.669370 -4116 963 6 0 -9.756394 20.612891 7.487522 -4117 963 4 0 -10.567829 20.596149 6.941769 -4118 963 4 0 -9.567427 19.672366 7.650269 -4119 964 6 0 -10.809623 -15.325182 16.646046 -4120 964 4 0 -10.540345 -15.380934 15.754906 -4121 964 4 0 -10.995048 -16.212302 17.003558 -4122 965 6 0 23.590175 -14.844140 18.091313 -4123 965 4 0 23.082950 -15.642639 17.817614 -4124 965 4 0 22.918432 -14.433938 18.680116 -4125 966 6 0 -9.843301 16.099124 8.917553 -4126 966 4 0 -10.800912 15.942477 8.746196 -4127 966 4 0 -9.776206 16.007775 9.870062 -4128 967 6 0 -15.969686 15.153089 5.232592 -4129 967 4 0 -15.190596 15.577230 4.796399 -4130 967 4 0 -16.653218 15.791665 5.086615 -4131 968 6 0 -14.522038 4.774109 20.092720 -4132 968 4 0 -13.726552 4.726517 19.600040 -4133 968 4 0 -14.275341 5.232921 20.890928 -4134 969 6 0 -19.150467 -13.472817 -2.000864 -4135 969 4 0 -19.948375 -14.097323 -2.133949 -4136 969 4 0 -18.565882 -13.718795 -2.719742 -4137 970 6 0 26.570568 3.571434 2.677152 -4138 970 4 0 26.009960 3.474978 1.867261 -4139 970 4 0 25.979473 4.132392 3.254985 -4140 971 6 0 2.963742 -20.267378 17.680551 -4141 971 4 0 2.939273 -19.702759 18.451804 -4142 971 4 0 3.704894 -20.009537 17.129551 -4143 972 6 0 12.886914 -16.854820 -15.969948 -4144 972 4 0 13.277380 -15.998244 -16.290560 -4145 972 4 0 12.084202 -16.946569 -16.485310 -4146 973 6 0 -13.403098 20.670706 14.180090 -4147 973 4 0 -12.697115 20.129500 13.825532 -4148 973 4 0 -13.078241 21.562186 14.353615 -4149 974 6 0 1.263724 -2.316623 11.541630 -4150 974 4 0 1.604989 -3.147382 11.057854 -4151 974 4 0 1.301508 -2.419331 12.514250 -4152 975 6 0 16.027424 -2.901060 -7.834089 -4153 975 4 0 15.527925 -3.644628 -8.229138 -4154 975 4 0 15.964477 -2.241942 -8.584411 -4155 976 6 0 20.574908 7.015109 -16.355513 -4156 976 4 0 20.799767 7.912603 -16.672696 -4157 976 4 0 19.614717 7.020855 -16.464707 -4158 977 6 0 -9.799678 -16.315433 -2.735469 -4159 977 4 0 -9.082163 -15.876270 -3.158920 -4160 977 4 0 -9.675027 -17.234496 -2.912849 -4161 978 6 0 19.925358 -1.799248 -13.616500 -4162 978 4 0 19.041533 -1.607762 -13.949745 -4163 978 4 0 20.105803 -1.002750 -13.099573 -4164 979 6 0 26.502531 14.202393 -14.528425 -4165 979 4 0 25.566109 14.188457 -14.685868 -4166 979 4 0 26.586381 14.616670 -13.692642 -4167 980 6 0 -3.640972 -15.964509 3.441932 -4168 980 4 0 -3.916866 -16.633969 4.049731 -4169 980 4 0 -3.180242 -16.493582 2.755249 -4170 981 6 0 20.157853 -15.783144 2.660570 -4171 981 4 0 20.419750 -16.681495 2.950489 -4172 981 4 0 19.984795 -15.805827 1.709836 -4173 982 6 0 3.128568 11.959447 -14.685598 -4174 982 4 0 2.607191 12.662191 -15.102263 -4175 982 4 0 3.769283 12.428495 -14.079944 -4176 983 6 0 -24.815536 -15.542873 4.007555 -4177 983 4 0 -24.218085 -16.000016 3.406953 -4178 983 4 0 -25.315854 -15.091766 3.403899 -4179 984 6 0 19.308952 20.661672 -11.377272 -4180 984 4 0 19.335667 21.503703 -10.905560 -4181 984 4 0 20.214980 20.602723 -11.631713 -4182 985 6 0 13.542822 -5.649499 0.333332 -4183 985 4 0 13.963629 -4.763289 0.274336 -4184 985 4 0 12.814580 -5.810940 -0.269097 -4185 986 6 0 13.690049 -20.143279 -5.943461 -4186 986 4 0 13.436356 -20.544177 -6.811045 -4187 986 4 0 14.540599 -19.746894 -6.080417 -4188 987 6 0 -15.552613 1.765055 -16.570745 -4189 987 4 0 -15.053582 2.345281 -15.988522 -4190 987 4 0 -15.170829 0.889200 -16.752662 -4191 988 6 0 18.304944 6.143260 -6.070829 -4192 988 4 0 18.125046 5.326107 -5.570747 -4193 988 4 0 18.266448 6.784180 -5.360045 -4194 989 6 0 2.506981 -17.274997 10.100766 -4195 989 4 0 3.347828 -17.659592 10.064456 -4196 989 4 0 2.856471 -16.401034 10.442415 -4197 990 6 0 -19.165460 9.947070 1.363209 -4198 990 4 0 -18.730236 10.366229 0.602857 -4199 990 4 0 -18.849961 10.481480 2.151944 -4200 991 6 0 -25.980688 17.933161 -0.316559 -4201 991 4 0 -26.443527 17.228913 -0.781861 -4202 991 4 0 -25.367896 18.145268 -0.998602 -4203 992 6 0 -8.979352 -14.825818 -16.044347 -4204 992 4 0 -8.232685 -15.013438 -15.478412 -4205 992 4 0 -9.593300 -15.565144 -15.856307 -4206 993 6 0 -26.878522 10.651550 -5.997590 -4207 993 4 0 -27.657923 11.080372 -6.414692 -4208 993 4 0 -26.575102 11.315809 -5.418717 -4209 994 6 0 25.946197 20.187421 -17.138659 -4210 994 4 0 26.747885 20.729551 -17.283461 -4211 994 4 0 25.893413 20.171520 -16.172728 -4212 995 6 0 -22.758506 -11.646357 10.203824 -4213 995 4 0 -22.294597 -11.119698 9.558550 -4214 995 4 0 -22.038786 -12.335635 10.328914 -4215 996 6 0 5.051118 -7.506736 -18.096705 -4216 996 4 0 5.890399 -6.995469 -18.089124 -4217 996 4 0 4.432798 -7.081744 -18.676680 -4218 997 6 0 -25.361275 -6.967887 -18.797135 -4219 997 4 0 -24.723765 -6.707007 -18.115496 -4220 997 4 0 -25.259315 -7.901704 -18.865340 -4221 998 6 0 -2.799085 -16.680409 -5.658803 -4222 998 4 0 -3.041668 -16.532466 -4.707237 -4223 998 4 0 -2.655725 -17.646573 -5.729646 -4224 999 6 0 6.961841 -0.650018 14.982518 -4225 999 4 0 7.049840 -0.822572 15.899427 -4226 999 4 0 7.585417 -1.245556 14.495279 -4227 1000 6 0 -27.328225 -2.775920 4.654966 -4228 1000 4 0 -28.131668 -3.256883 4.960696 -4229 1000 4 0 -26.702154 -2.749977 5.390082 -4230 1001 6 0 -10.545176 15.887401 -11.516094 -4231 1001 4 0 -11.354652 16.437925 -11.631152 -4232 1001 4 0 -10.234139 15.573972 -12.408175 -4233 1002 6 0 27.293890 -3.784569 13.095470 -4234 1002 4 0 27.629930 -4.552840 12.571336 -4235 1002 4 0 27.297508 -4.139921 14.014667 -4236 1003 6 0 26.677289 -8.930589 -5.080635 -4237 1003 4 0 27.349144 -8.367067 -5.399678 -4238 1003 4 0 26.178389 -8.423219 -4.437089 -4239 1004 6 0 26.303353 -13.709693 -10.199064 -4240 1004 4 0 26.819339 -13.575870 -11.047002 -4241 1004 4 0 26.995460 -13.448744 -9.504732 -4242 1005 6 0 -5.782538 -6.137070 -18.577558 -4243 1005 4 0 -5.225175 -5.601455 -18.004594 -4244 1005 4 0 -5.277523 -6.828742 -18.969936 -4245 1006 6 0 -10.751593 15.373515 -8.362078 -4246 1006 4 0 -10.116580 15.133048 -9.031534 -4247 1006 4 0 -11.426882 15.817389 -8.872810 -4248 1007 6 0 16.641528 -6.647086 14.042481 -4249 1007 4 0 16.877857 -5.780320 14.352388 -4250 1007 4 0 15.723201 -6.556522 13.694961 -4251 1008 6 0 -9.692102 -20.433174 12.075319 -4252 1008 4 0 -9.015496 -20.798185 11.574612 -4253 1008 4 0 -10.349277 -21.179838 12.030713 -4254 1009 6 0 -3.342987 5.338933 20.099174 -4255 1009 4 0 -3.147711 5.827567 20.954747 -4256 1009 4 0 -4.124775 5.753362 19.736033 -4257 1010 6 0 22.616008 -14.603236 0.953729 -4258 1010 4 0 21.991188 -13.989371 1.394272 -4259 1010 4 0 22.974372 -14.081510 0.229956 -4260 1011 6 0 -8.097592 12.140479 -19.585886 -4261 1011 4 0 -8.453866 12.623380 -20.326053 -4262 1011 4 0 -8.784224 11.654989 -19.152969 -4263 1012 6 0 -21.232297 5.610953 -16.679404 -4264 1012 4 0 -20.585466 5.060918 -17.156512 -4265 1012 4 0 -21.930038 5.836903 -17.294471 -4266 1013 6 0 -10.747633 18.133699 -14.681278 -4267 1013 4 0 -10.847151 18.670752 -15.499579 -4268 1013 4 0 -9.785896 18.213162 -14.415037 -4269 1014 6 0 5.277447 -4.914937 -12.832056 -4270 1014 4 0 4.837973 -4.063025 -13.209955 -4271 1014 4 0 6.186619 -4.697637 -12.711347 -4272 1015 6 0 20.041500 5.021710 -2.968457 -4273 1015 4 0 19.672986 5.469423 -2.234503 -4274 1015 4 0 20.344328 4.132583 -2.637240 -4275 1016 6 0 17.907741 2.778212 -8.037993 -4276 1016 4 0 18.567517 3.366180 -8.410651 -4277 1016 4 0 17.288995 3.302520 -7.441301 -4278 1017 6 0 5.562515 -18.543574 -19.590057 -4279 1017 4 0 6.312662 -18.495893 -20.210476 -4280 1017 4 0 5.830551 -17.824826 -18.960179 -4281 1018 6 0 12.736551 -13.896404 -1.831403 -4282 1018 4 0 12.773597 -12.929037 -1.656141 -4283 1018 4 0 13.175198 -14.041740 -2.708482 -4284 1019 6 0 -4.469179 -3.097942 -13.481704 -4285 1019 4 0 -3.873920 -2.479353 -13.901987 -4286 1019 4 0 -5.276658 -2.695674 -13.122340 -4287 1020 6 0 -21.439043 8.219030 17.863426 -4288 1020 4 0 -21.056703 8.853759 17.338517 -4289 1020 4 0 -21.129569 7.386574 17.512818 -4290 1021 6 0 -20.342022 -7.199464 17.782819 -4291 1021 4 0 -19.811208 -6.577246 18.288787 -4292 1021 4 0 -19.701668 -7.908647 17.571092 -4293 1022 6 0 -14.263922 5.278640 -18.510906 -4294 1022 4 0 -13.564113 4.937165 -17.913388 -4295 1022 4 0 -14.930181 4.580837 -18.615930 -4296 1023 6 0 16.913731 -14.141037 14.480884 -4297 1023 4 0 16.066655 -13.798463 14.461234 -4298 1023 4 0 17.548578 -13.399940 14.431310 -4299 1024 6 0 -25.968088 14.659464 5.007859 -4300 1024 4 0 -25.454004 13.822928 4.891375 -4301 1024 4 0 -26.104124 14.757551 5.974942 -4302 1025 6 0 -18.135969 17.732537 5.080161 -4303 1025 4 0 -18.773193 18.355342 5.390012 -4304 1025 4 0 -18.159466 17.860761 4.093910 -4305 1026 6 0 -27.275820 -16.400609 -7.043757 -4306 1026 4 0 -26.590275 -16.756481 -6.431378 -4307 1026 4 0 -27.617212 -15.617979 -6.640114 -4308 1027 6 0 24.748058 17.280534 18.064239 -4309 1027 4 0 25.308718 17.915370 18.504903 -4310 1027 4 0 24.056361 17.050512 18.710421 -4311 1028 6 0 -24.811053 1.584408 5.834113 -4312 1028 4 0 -25.507909 1.858017 6.420755 -4313 1028 4 0 -25.030959 2.043401 4.912778 -4314 1029 6 0 -17.538048 -16.019040 8.437894 -4315 1029 4 0 -16.656025 -15.917276 8.786670 -4316 1029 4 0 -18.001949 -16.630915 9.146335 -4317 1030 6 0 24.760362 7.007344 2.270076 -4318 1030 4 0 25.402754 6.314627 2.489308 -4319 1030 4 0 23.915754 6.586671 2.268737 -4320 1031 6 0 25.788659 -3.059441 10.761911 -4321 1031 4 0 26.310282 -3.490606 11.381049 -4322 1031 4 0 26.152501 -2.184136 10.493232 -4323 1032 6 0 0.555207 13.578019 -13.771204 -4324 1032 4 0 0.341766 12.780750 -14.192088 -4325 1032 4 0 0.413626 13.443525 -12.823611 -4326 1033 6 0 20.410457 17.119094 12.037026 -4327 1033 4 0 20.229518 17.254716 12.960534 -4328 1033 4 0 19.888401 16.300517 11.792550 -4329 1034 6 0 -23.997550 7.377972 16.665323 -4330 1034 4 0 -23.725736 7.038438 15.778438 -4331 1034 4 0 -23.233133 7.945952 17.026136 -4332 1035 6 0 10.209255 5.785175 12.171401 -4333 1035 4 0 10.101397 6.356166 11.459081 -4334 1035 4 0 9.657068 5.061974 12.024038 -4335 1036 6 0 18.434676 -10.560721 -17.755033 -4336 1036 4 0 18.443899 -11.522200 -17.622101 -4337 1036 4 0 18.319805 -10.178413 -16.882655 -4338 1037 6 0 -27.095192 -12.657493 -12.643385 -4339 1037 4 0 -26.627310 -12.318558 -13.484881 -4340 1037 4 0 -26.470420 -12.949131 -11.963689 -4341 1038 6 0 -16.616222 15.445597 -12.118963 -4342 1038 4 0 -16.900898 14.503610 -11.855586 -4343 1038 4 0 -15.694269 15.632029 -11.755889 -4344 1039 6 0 21.704052 -7.110846 5.569340 -4345 1039 4 0 21.462097 -8.042671 5.894386 -4346 1039 4 0 20.943089 -6.635884 5.906995 -4347 1040 6 0 18.206432 16.827370 1.010928 -4348 1040 4 0 17.640465 17.264033 0.353478 -4349 1040 4 0 17.852918 17.062780 1.898646 -4350 1041 6 0 -11.473367 18.497190 -2.566431 -4351 1041 4 0 -11.979906 19.196582 -2.198797 -4352 1041 4 0 -11.280546 18.932999 -3.450291 -4353 1042 6 0 17.797648 10.068787 -6.366632 -4354 1042 4 0 17.894506 9.407090 -5.699458 -4355 1042 4 0 18.545928 9.973231 -6.994936 -4356 1043 6 0 -18.401148 -11.350055 -12.827243 -4357 1043 4 0 -18.476782 -10.412318 -13.195678 -4358 1043 4 0 -17.491834 -11.585994 -12.934422 -4359 1044 6 0 -16.495719 -5.941792 10.422239 -4360 1044 4 0 -16.334766 -5.213442 11.122849 -4361 1044 4 0 -16.639135 -6.780551 10.923477 -4362 1045 6 0 -11.586396 18.803652 -7.549338 -4363 1045 4 0 -12.019098 18.189302 -8.166804 -4364 1045 4 0 -11.712347 18.317066 -6.668883 -4365 1046 6 0 11.058497 -1.697211 6.108850 -4366 1046 4 0 11.596453 -0.983751 6.451941 -4367 1046 4 0 10.144328 -1.357434 6.135852 -4368 1047 6 0 -6.655801 13.749288 -17.439254 -4369 1047 4 0 -7.132448 13.358752 -18.156046 -4370 1047 4 0 -7.118927 14.596314 -17.196637 -4371 1048 6 0 1.472049 -16.138831 -18.127087 -4372 1048 4 0 0.854396 -15.448228 -18.418147 -4373 1048 4 0 2.130556 -15.578106 -17.697816 -4374 1049 6 0 20.585602 0.045789 -20.805188 -4375 1049 4 0 19.811710 0.249922 -20.316920 -4376 1049 4 0 20.451948 -0.908979 -20.865716 -4377 1050 6 0 -17.322452 12.895993 -11.204513 -4378 1050 4 0 -17.802771 12.549260 -12.003007 -4379 1050 4 0 -17.950866 13.176295 -10.574188 -4380 1051 6 0 -5.523481 17.380120 9.246553 -4381 1051 4 0 -6.455503 17.665024 9.326329 -4382 1051 4 0 -5.168113 17.988295 8.544540 -4383 1052 6 0 -20.625677 5.350199 17.142096 -4384 1052 4 0 -20.365541 5.269750 16.185658 -4385 1052 4 0 -21.560214 5.201087 17.226176 -4386 1053 6 0 14.783181 -14.244465 0.085624 -4387 1053 4 0 14.103412 -14.020780 -0.585079 -4388 1053 4 0 15.175676 -13.378076 0.287496 -4389 1054 6 0 -6.126500 15.521051 20.750377 -4390 1054 4 0 -5.864785 16.375379 20.437098 -4391 1054 4 0 -5.831488 14.924080 20.076176 -4392 1055 6 0 23.807408 -1.524862 20.387679 -4393 1055 4 0 23.526614 -0.919002 21.138248 -4394 1055 4 0 24.692883 -1.828224 20.645004 -4395 1056 6 0 -19.809983 -10.410676 13.714221 -4396 1056 4 0 -20.768119 -10.598102 13.488906 -4397 1056 4 0 -19.553271 -11.125518 14.242975 -4398 1057 6 0 10.977545 9.011145 -2.389433 -4399 1057 4 0 10.555694 9.915559 -2.389522 -4400 1057 4 0 11.154202 8.870964 -1.470695 -4401 1058 6 0 -1.783860 4.881032 16.604931 -4402 1058 4 0 -1.311789 5.388703 17.223932 -4403 1058 4 0 -2.422445 4.514982 17.225489 -4404 1059 6 0 7.835617 -8.106110 -15.760424 -4405 1059 4 0 7.624633 -7.756681 -14.894547 -4406 1059 4 0 8.420342 -7.335138 -16.124751 -4407 1060 6 0 -23.662148 -13.962817 6.282978 -4408 1060 4 0 -23.067991 -14.398941 6.936570 -4409 1060 4 0 -23.877149 -14.577723 5.532763 -4410 1061 6 0 -23.624539 2.173832 -0.854956 -4411 1061 4 0 -23.179146 2.179020 0.040340 -4412 1061 4 0 -23.749597 1.237465 -1.001396 -4413 1062 6 0 -21.224847 4.257385 -6.009865 -4414 1062 4 0 -20.741474 3.800756 -5.299605 -4415 1062 4 0 -22.182298 4.137922 -5.723698 -4416 1063 6 0 -7.017487 16.063624 -12.051636 -4417 1063 4 0 -6.269158 16.416276 -11.536793 -4418 1063 4 0 -7.636713 15.594733 -11.454123 -4419 1064 6 0 -5.651528 10.093505 -13.321462 -4420 1064 4 0 -6.401351 10.663800 -13.086078 -4421 1064 4 0 -5.597617 10.115851 -14.301208 -4422 1065 6 0 21.418715 -14.140702 -12.149975 -4423 1065 4 0 21.861018 -14.674641 -11.447553 -4424 1065 4 0 21.182805 -13.281849 -11.830093 -4425 1066 6 0 11.675702 -2.428019 -16.058290 -4426 1066 4 0 12.296485 -3.131417 -15.821102 -4427 1066 4 0 10.819347 -2.825354 -16.198440 -4428 1067 6 0 22.979820 -2.598953 7.858168 -4429 1067 4 0 22.305897 -3.288078 7.958439 -4430 1067 4 0 22.577225 -1.844154 8.317572 -4431 1068 6 0 -12.448543 -5.982245 -10.570856 -4432 1068 4 0 -12.345287 -6.440367 -11.438582 -4433 1068 4 0 -12.479780 -5.112730 -10.871625 -4434 1069 6 0 -21.326982 14.741209 3.984994 -4435 1069 4 0 -22.133596 15.218464 4.095957 -4436 1069 4 0 -21.095649 14.791647 3.001164 -4437 1070 6 0 -18.292976 8.601702 17.515296 -4438 1070 4 0 -17.819784 7.959109 16.915944 -4439 1070 4 0 -18.716579 9.254092 16.954312 -4440 1071 6 0 20.829524 -9.495435 17.330944 -4441 1071 4 0 20.166412 -8.937403 16.904816 -4442 1071 4 0 20.227087 -10.108486 17.846508 -4443 1072 6 0 20.700328 -6.588173 14.108279 -4444 1072 4 0 21.318200 -6.371434 13.409947 -4445 1072 4 0 20.919049 -5.966297 14.775431 -4446 1073 6 0 20.232319 2.519356 -1.744863 -4447 1073 4 0 19.792632 2.343537 -0.866566 -4448 1073 4 0 20.751642 1.718603 -1.892919 -4449 1074 6 0 15.047686 14.467227 0.247890 -4450 1074 4 0 15.482736 13.695414 -0.222271 -4451 1074 4 0 15.218594 15.203623 -0.400616 -4452 1075 6 0 24.814901 -4.572712 18.521288 -4453 1075 4 0 24.436069 -3.989712 17.861088 -4454 1075 4 0 24.560432 -4.263207 19.423396 -4455 1076 6 0 3.169892 -14.115589 5.242292 -4456 1076 4 0 2.664005 -13.989979 6.094893 -4457 1076 4 0 4.025199 -14.428367 5.639157 -4458 1077 6 0 -17.864265 -2.850216 -5.852738 -4459 1077 4 0 -17.430066 -2.321482 -5.131734 -4460 1077 4 0 -17.446095 -3.672125 -5.727214 -4461 1078 6 0 -13.642312 16.367207 3.840240 -4462 1078 4 0 -13.546920 17.318166 3.892058 -4463 1078 4 0 -12.985388 16.154870 4.544614 -4464 1079 6 0 15.575472 3.168399 -6.551464 -4465 1079 4 0 15.114514 3.591709 -7.323565 -4466 1079 4 0 15.203187 3.608807 -5.831817 -4467 1080 6 0 -21.816911 -17.666243 7.967285 -4468 1080 4 0 -21.649191 -17.232658 7.144499 -4469 1080 4 0 -22.407552 -17.039323 8.334081 -4470 1081 6 0 -19.125021 -12.172620 15.597940 -4471 1081 4 0 -18.215275 -12.242849 15.770287 -4472 1081 4 0 -19.633754 -12.872939 15.973922 -4473 1082 6 0 17.584300 -5.074564 -0.037211 -4474 1082 4 0 18.183319 -5.137038 0.675699 -4475 1082 4 0 18.235909 -5.047683 -0.784982 -4476 1083 6 0 26.562235 4.146721 -10.779327 -4477 1083 4 0 27.258204 4.596271 -10.364313 -4478 1083 4 0 26.892796 3.237656 -11.037254 -4479 1084 6 0 -23.034850 1.331983 -7.473112 -4480 1084 4 0 -22.263084 1.153047 -6.915575 -4481 1084 4 0 -23.725786 1.086847 -6.826224 -4482 1085 6 0 24.491038 14.753421 2.384575 -4483 1085 4 0 24.275342 13.963741 2.927789 -4484 1085 4 0 25.462558 14.841355 2.559853 -4485 1086 6 0 25.756605 20.905461 -14.371089 -4486 1086 4 0 25.459034 20.605712 -13.483891 -4487 1086 4 0 25.637109 21.868510 -14.335232 -4488 1087 6 0 18.144532 -1.757335 -11.270502 -4489 1087 4 0 18.514080 -2.646244 -11.055555 -4490 1087 4 0 18.939318 -1.202686 -11.251734 -4491 1088 6 0 -8.201074 -18.018606 -17.312094 -4492 1088 4 0 -8.700168 -17.307968 -17.835946 -4493 1088 4 0 -7.577873 -18.381345 -17.962687 -4494 1089 6 0 -9.369914 -19.217851 -15.403305 -4495 1089 4 0 -8.952768 -18.975805 -16.243189 -4496 1089 4 0 -8.911643 -18.742350 -14.709664 -4497 1090 6 0 20.100577 4.488027 -15.212556 -4498 1090 4 0 20.248911 5.438169 -15.424742 -4499 1090 4 0 20.660237 3.933680 -15.689536 -4500 1091 6 0 -19.712024 -15.323556 12.551955 -4501 1091 4 0 -19.317175 -16.207750 12.463402 -4502 1091 4 0 -19.212616 -14.787825 13.210358 -4503 1092 6 0 3.258787 -7.943131 12.290678 -4504 1092 4 0 2.342628 -8.287555 12.320149 -4505 1092 4 0 3.267355 -6.993463 12.332634 -4506 1093 6 0 -18.302710 1.278985 -16.334436 -4507 1093 4 0 -17.378406 1.373256 -16.132103 -4508 1093 4 0 -18.777760 1.517880 -15.493665 -4509 1094 6 0 16.870546 4.656852 -17.868704 -4510 1094 4 0 15.857496 4.704340 -17.988259 -4511 1094 4 0 17.247038 4.338791 -18.723974 -4512 1095 6 0 -15.333473 15.071500 7.805725 -4513 1095 4 0 -15.704647 14.257623 8.137122 -4514 1095 4 0 -15.627172 15.251727 6.915271 -4515 1096 6 0 9.979483 20.165851 2.918770 -4516 1096 4 0 9.638769 20.645174 2.150266 -4517 1096 4 0 9.859690 19.210620 2.805973 -4518 1097 6 0 23.413497 4.631399 15.271695 -4519 1097 4 0 23.659592 4.570914 14.363590 -4520 1097 4 0 23.076746 5.481003 15.471203 -4521 1098 6 0 23.514270 -0.269090 17.919270 -4522 1098 4 0 23.883706 -0.646818 18.744448 -4523 1098 4 0 22.647737 0.129763 18.103196 -4524 1099 6 0 -24.064290 4.819702 1.332253 -4525 1099 4 0 -24.383325 4.040819 1.008702 -4526 1099 4 0 -23.189236 4.997095 0.898826 -4527 1100 6 0 -25.779315 -8.150537 18.610217 -4528 1100 4 0 -24.782772 -7.888401 18.544405 -4529 1100 4 0 -26.257671 -7.381934 18.370006 -4530 1101 6 0 23.115913 16.716123 3.668102 -4531 1101 4 0 23.749362 16.385349 2.997452 -4532 1101 4 0 23.088241 17.666029 3.599261 -4533 1102 6 0 -20.088868 -15.143633 -10.159937 -4534 1102 4 0 -19.953025 -14.270168 -10.582681 -4535 1102 4 0 -19.990998 -15.687042 -10.954781 -4536 1103 6 0 7.102126 -1.136927 20.971306 -4537 1103 4 0 6.576190 -1.521838 20.280208 -4538 1103 4 0 7.955207 -1.040834 20.509983 -4539 1104 6 0 -2.534299 9.690544 11.933304 -4540 1104 4 0 -2.860248 8.888179 11.453477 -4541 1104 4 0 -1.828854 10.072496 11.393589 -4542 1105 6 0 12.023524 -9.150206 -14.165841 -4543 1105 4 0 11.362618 -9.759930 -14.520833 -4544 1105 4 0 12.740525 -9.263946 -14.788240 -4545 1106 6 0 15.791803 18.545995 0.850378 -4546 1106 4 0 16.437977 18.981342 1.416680 -4547 1106 4 0 14.975349 18.624193 1.311898 -4548 1107 6 0 -23.993331 13.937802 7.429388 -4549 1107 4 0 -23.946766 13.591295 6.487146 -4550 1107 4 0 -23.318125 14.639075 7.439315 -4551 1108 6 0 23.938328 -2.346007 3.554880 -4552 1108 4 0 24.343685 -3.093714 4.072487 -4553 1108 4 0 24.649326 -2.174810 2.889988 -4554 1109 6 0 -1.744771 13.957566 2.002292 -4555 1109 4 0 -0.940707 14.398422 2.247093 -4556 1109 4 0 -2.025476 14.420450 1.204293 -4557 1110 6 0 -25.534328 -15.482539 7.809635 -4558 1110 4 0 -25.054678 -15.173162 7.005447 -4559 1110 4 0 -26.465036 -15.629268 7.587481 -4560 1111 6 0 24.624742 -18.307755 -10.821110 -4561 1111 4 0 23.724217 -18.723401 -10.975653 -4562 1111 4 0 24.780187 -17.602754 -11.546790 -4563 1112 6 0 -21.325143 19.316329 -1.400937 -4564 1112 4 0 -21.154588 18.656956 -0.705637 -4565 1112 4 0 -20.679486 19.156150 -2.095481 -4566 1113 6 0 0.559384 -5.922570 14.213390 -4567 1113 4 0 1.239405 -5.963730 14.899585 -4568 1113 4 0 0.030681 -5.131536 14.297850 -4569 1114 6 0 7.056613 12.758986 15.777863 -4570 1114 4 0 6.345829 12.596606 16.456405 -4571 1114 4 0 6.917568 12.084839 15.095389 -4572 1115 6 0 7.882824 3.878180 -19.492657 -4573 1115 4 0 7.490185 4.569137 -19.983338 -4574 1115 4 0 7.617907 3.037912 -19.945297 -4575 1116 6 0 -4.242915 -9.821169 16.240099 -4576 1116 4 0 -5.114830 -10.078772 16.528494 -4577 1116 4 0 -4.353835 -8.852979 15.979121 -4578 1117 6 0 15.302976 18.208896 -11.851032 -4579 1117 4 0 14.901111 18.506138 -12.642478 -4580 1117 4 0 14.917266 17.320837 -11.712610 -4581 1118 6 0 -18.266869 -16.450266 -8.528802 -4582 1118 4 0 -19.072723 -16.071961 -9.086324 -4583 1118 4 0 -18.243043 -17.366820 -8.807270 -4584 1119 6 0 16.535819 -20.059315 20.261479 -4585 1119 4 0 16.531825 -20.982895 19.988148 -4586 1119 4 0 16.217098 -19.563433 19.483491 -4587 1120 6 0 -10.711611 3.116140 -11.835025 -4588 1120 4 0 -10.699224 2.230856 -12.204415 -4589 1120 4 0 -10.469479 3.689824 -12.532473 -4590 1121 6 0 -3.907796 14.129489 -14.135830 -4591 1121 4 0 -3.774958 15.065764 -14.110303 -4592 1121 4 0 -4.871885 13.969469 -14.280187 -4593 1122 6 0 -0.848559 15.883551 -14.784892 -4594 1122 4 0 -0.414200 14.990499 -14.630689 -4595 1122 4 0 -1.164070 15.745918 -15.703167 -4596 1123 6 0 26.710694 15.162885 -7.381020 -4597 1123 4 0 26.708875 16.144027 -7.444500 -4598 1123 4 0 27.516272 14.997257 -7.900997 -4599 1124 6 0 -20.320110 2.222669 -14.437513 -4600 1124 4 0 -20.674693 1.937159 -13.587288 -4601 1124 4 0 -21.090888 2.252982 -14.954492 -4602 1125 6 0 -18.681714 17.640935 -1.514728 -4603 1125 4 0 -19.273979 17.179134 -2.084688 -4604 1125 4 0 -18.333083 16.926527 -0.959606 -4605 1126 6 0 26.297214 0.194896 -8.814341 -4606 1126 4 0 26.092612 0.771392 -8.062520 -4607 1126 4 0 25.469129 -0.223458 -9.080468 -4608 1127 6 0 5.191134 -6.332696 -10.274288 -4609 1127 4 0 6.147598 -6.194127 -10.166488 -4610 1127 4 0 4.968608 -5.815003 -11.012193 -4611 1128 6 0 20.219068 -19.874563 -6.779564 -4612 1128 4 0 19.984433 -20.709740 -7.181101 -4613 1128 4 0 20.478152 -20.150413 -5.862690 -4614 1129 6 0 15.925069 -5.315100 -4.962971 -4615 1129 4 0 16.483651 -4.538813 -4.855095 -4616 1129 4 0 16.031011 -5.844220 -4.094051 -4617 1130 6 0 -24.041642 -19.508457 3.561309 -4618 1130 4 0 -23.889244 -19.214184 4.445568 -4619 1130 4 0 -23.734917 -20.488280 3.584072 -4620 1131 6 0 -7.947126 8.409362 14.208637 -4621 1131 4 0 -8.729737 8.295090 13.605991 -4622 1131 4 0 -7.220157 7.896970 13.768244 -4623 1132 6 0 -20.888915 18.615896 3.147997 -4624 1132 4 0 -20.353651 18.339741 3.899224 -4625 1132 4 0 -20.608848 18.126465 2.400982 -4626 1133 6 0 26.799597 -16.513942 12.340813 -4627 1133 4 0 27.311676 -15.749176 12.455669 -4628 1133 4 0 26.641412 -16.884054 13.252799 -4629 1134 6 0 22.610810 -16.125525 -11.025534 -4630 1134 4 0 23.428805 -16.214604 -10.496780 -4631 1134 4 0 22.231404 -17.004775 -11.137826 -4632 1135 6 0 23.631086 9.762764 -6.151528 -4633 1135 4 0 22.831437 10.283165 -6.251895 -4634 1135 4 0 23.313903 8.866850 -6.410178 -4635 1136 6 0 10.407629 -5.135788 9.642425 -4636 1136 4 0 9.500671 -5.522467 9.593528 -4637 1136 4 0 10.722620 -5.079856 8.742604 -4638 1137 6 0 4.000382 -9.483456 -16.043131 -4639 1137 4 0 4.388443 -8.972484 -16.767773 -4640 1137 4 0 3.270597 -9.958423 -16.410357 -4641 1138 6 0 -25.904986 -15.880364 18.652683 -4642 1138 4 0 -26.778482 -15.886913 19.026359 -4643 1138 4 0 -25.526797 -16.780938 18.932335 -4644 1139 6 0 15.308933 1.325497 -13.930838 -4645 1139 4 0 15.049598 0.974163 -14.793125 -4646 1139 4 0 14.735466 2.123881 -13.829588 -4647 1140 6 0 -6.379415 2.888159 -18.944523 -4648 1140 4 0 -6.573457 2.028181 -19.291846 -4649 1140 4 0 -5.489918 2.985716 -19.266815 -4650 1141 6 0 -1.982477 0.360990 19.729630 -4651 1141 4 0 -2.393479 -0.007753 20.516214 -4652 1141 4 0 -2.616886 0.223553 19.013623 -4653 1142 6 0 1.410741 17.503605 17.946189 -4654 1142 4 0 1.299933 17.358511 17.001928 -4655 1142 4 0 1.382712 16.600387 18.282286 -4656 1143 6 0 -17.081613 19.032309 -4.304375 -4657 1143 4 0 -18.004189 18.728506 -4.171643 -4658 1143 4 0 -16.569290 18.434220 -3.790534 -4659 1144 6 0 26.981274 -11.552908 -3.820441 -4660 1144 4 0 26.121174 -11.624996 -4.253473 -4661 1144 4 0 27.276376 -10.703146 -4.209015 -4662 1145 6 0 20.095481 18.572235 3.036961 -4663 1145 4 0 20.026299 17.806007 3.594224 -4664 1145 4 0 20.832186 19.036343 3.467658 -4665 1146 6 0 -19.905861 6.946943 4.083849 -4666 1146 4 0 -19.307403 7.160688 3.357801 -4667 1146 4 0 -20.728729 7.427643 3.991449 -4668 1147 6 0 22.217595 -4.822160 -10.650121 -4669 1147 4 0 22.159340 -5.054178 -11.530210 -4670 1147 4 0 21.255204 -4.714847 -10.351112 -4671 1148 6 0 12.390352 -19.538948 -0.083493 -4672 1148 4 0 13.062326 -18.900361 -0.469572 -4673 1148 4 0 11.739170 -19.679826 -0.768861 -4674 1149 6 0 -11.756735 -11.595474 -18.753407 -4675 1149 4 0 -10.845705 -11.914606 -18.999006 -4676 1149 4 0 -11.631200 -10.619419 -18.528946 -4677 1150 6 0 16.531650 8.079043 16.659190 -4678 1150 4 0 16.426030 8.463579 15.788072 -4679 1150 4 0 17.442132 8.278108 16.859520 -4680 1151 6 0 10.052731 8.649788 -10.126307 -4681 1151 4 0 10.131192 7.907466 -9.580859 -4682 1151 4 0 10.118299 9.470033 -9.652222 -4683 1152 6 0 10.138877 6.520965 -16.282122 -4684 1152 4 0 9.429867 6.198945 -15.746097 -4685 1152 4 0 9.762597 7.172991 -16.879414 -4686 1153 6 0 -5.128627 7.237138 -16.384778 -4687 1153 4 0 -4.943315 6.311211 -16.467826 -4688 1153 4 0 -4.299328 7.630954 -16.159960 -4689 1154 6 0 18.467732 -4.333427 -7.973507 -4690 1154 4 0 17.685481 -3.749427 -7.814406 -4691 1154 4 0 18.051764 -5.199527 -7.872728 -4692 1155 6 0 -22.790877 -7.110126 -2.658913 -4693 1155 4 0 -22.592444 -7.612682 -1.822969 -4694 1155 4 0 -23.671839 -6.831554 -2.552705 -4695 1156 6 0 -5.452870 -18.001674 4.454273 -4696 1156 4 0 -5.227357 -18.684872 5.061214 -4697 1156 4 0 -6.200455 -17.594596 4.818204 -4698 1157 6 0 6.056152 -17.434479 -7.972778 -4699 1157 4 0 6.787809 -18.060671 -8.028928 -4700 1157 4 0 5.440331 -17.702859 -7.267591 -4701 1158 6 0 1.714168 -18.930287 -17.718130 -4702 1158 4 0 1.740272 -18.003727 -18.035560 -4703 1158 4 0 0.785802 -19.119877 -17.580120 -4704 1159 6 0 12.454449 16.569541 -9.572034 -4705 1159 4 0 13.143421 15.995002 -9.358789 -4706 1159 4 0 11.970081 16.409711 -8.733167 -4707 1160 6 0 21.377566 -4.531623 -13.959167 -4708 1160 4 0 21.220313 -4.586863 -14.883806 -4709 1160 4 0 20.718007 -3.864167 -13.706228 -4710 1161 6 0 27.229945 -1.071212 -13.106863 -4711 1161 4 0 26.536738 -0.401088 -12.953451 -4712 1161 4 0 27.406489 -1.591477 -12.306455 -4713 1162 6 0 0.993205 -20.183906 13.537173 -4714 1162 4 0 1.864290 -20.100713 13.823720 -4715 1162 4 0 0.417346 -20.489716 14.247240 -4716 1163 6 0 22.306745 2.581458 8.736617 -4717 1163 4 0 22.972169 3.057047 8.241655 -4718 1163 4 0 21.515448 2.587605 8.237638 -4719 1164 6 0 -24.994740 17.845616 8.243126 -4720 1164 4 0 -25.935974 17.671320 8.306538 -4721 1164 4 0 -24.615426 17.427508 9.019818 -4722 1165 6 0 3.628195 -4.198159 -16.200147 -4723 1165 4 0 4.404223 -4.757640 -16.114355 -4724 1165 4 0 2.941004 -4.862278 -16.461468 -4725 1166 6 0 26.808990 -14.261974 -5.551088 -4726 1166 4 0 26.801404 -13.726938 -6.334245 -4727 1166 4 0 25.872464 -14.345791 -5.184066 -4728 1167 6 0 13.355891 -16.600141 -3.794039 -4729 1167 4 0 13.295908 -17.531097 -3.472837 -4730 1167 4 0 14.114590 -16.215977 -3.304966 -4731 1168 6 0 -5.285172 -14.650134 6.726219 -4732 1168 4 0 -5.321392 -15.573092 6.451324 -4733 1168 4 0 -5.705533 -14.040342 6.049451 -4734 1169 6 0 -15.245133 11.577568 10.198692 -4735 1169 4 0 -14.684069 10.842805 9.868029 -4736 1169 4 0 -15.899308 11.783343 9.507232 -4737 1170 6 0 17.485666 -16.919340 -6.354127 -4738 1170 4 0 17.235852 -17.135664 -7.261939 -4739 1170 4 0 18.432637 -16.981881 -6.360484 -4740 1171 6 0 -9.901382 -6.924152 -10.070687 -4741 1171 4 0 -10.735776 -6.481799 -9.885298 -4742 1171 4 0 -10.186933 -7.424453 -10.836686 -4743 1172 6 0 -24.779066 9.890774 -10.589824 -4744 1172 4 0 -24.555747 10.752218 -10.986744 -4745 1172 4 0 -24.892417 10.088688 -9.640328 -4746 1173 6 0 -22.615173 9.224641 6.611089 -4747 1173 4 0 -22.778201 8.680839 5.764537 -4748 1173 4 0 -23.446696 9.423303 6.964274 -4749 1174 6 0 9.268447 -16.931793 -5.987149 -4750 1174 4 0 8.956403 -16.451784 -6.788388 -4751 1174 4 0 9.877183 -16.351625 -5.503938 -4752 1175 6 0 -14.656535 1.482956 18.890158 -4753 1175 4 0 -15.369331 1.942366 19.276786 -4754 1175 4 0 -14.153965 0.952532 19.494908 -4755 1176 6 0 5.277331 10.616617 -11.480664 -4756 1176 4 0 5.005306 11.447583 -11.898782 -4757 1176 4 0 5.358629 10.918462 -10.514309 -4758 1177 6 0 25.665486 11.699398 -16.256540 -4759 1177 4 0 25.839240 12.448046 -15.719245 -4760 1177 4 0 25.814575 10.942656 -15.634104 -4761 1178 6 0 21.920761 20.073624 -12.126972 -4762 1178 4 0 22.552772 19.967397 -11.382127 -4763 1178 4 0 21.479644 19.202351 -12.146674 -4764 1179 6 0 10.003073 19.989386 -7.403776 -4765 1179 4 0 9.439166 20.478736 -6.817011 -4766 1179 4 0 9.975278 19.064238 -7.087034 -4767 1180 6 0 24.639512 10.361086 12.201260 -4768 1180 4 0 24.706246 9.532944 12.698966 -4769 1180 4 0 25.008910 11.010832 12.873283 -4770 1181 6 0 -4.551351 -13.614062 11.550986 -4771 1181 4 0 -3.695594 -13.200426 11.181108 -4772 1181 4 0 -4.841622 -13.040560 12.238016 -4773 1182 6 0 13.925499 -14.277948 -16.852509 -4774 1182 4 0 13.468499 -13.949023 -16.059490 -4775 1182 4 0 13.404967 -13.901558 -17.624653 -4776 1183 6 0 -8.822453 18.672284 -1.497284 -4777 1183 4 0 -9.773739 18.628726 -1.762866 -4778 1183 4 0 -8.737384 19.554941 -1.117958 -4779 1184 6 0 -22.502543 14.174443 -14.775760 -4780 1184 4 0 -23.095969 13.602099 -14.242424 -4781 1184 4 0 -22.857075 15.080918 -14.689705 -4782 1185 6 0 14.064111 -5.559010 13.387762 -4783 1185 4 0 14.064485 -4.565565 13.355502 -4784 1185 4 0 13.283489 -5.675258 12.845674 -4785 1186 6 0 1.894767 -5.320136 -19.924307 -4786 1186 4 0 1.751326 -5.338831 -18.971201 -4787 1186 4 0 2.815685 -5.078504 -20.067932 -4788 1187 6 0 25.294324 -10.049317 -2.168254 -4789 1187 4 0 24.998964 -9.181655 -2.438448 -4790 1187 4 0 25.460965 -9.966915 -1.197557 -4791 1188 6 0 6.479700 -19.891353 1.298943 -4792 1188 4 0 5.533528 -20.103717 1.361966 -4793 1188 4 0 6.573201 -19.075339 0.809570 -4794 1189 6 0 -27.363431 -16.882485 4.699786 -4795 1189 4 0 -26.488335 -16.423824 4.667383 -4796 1189 4 0 -27.778495 -16.519493 5.529189 -4797 1190 6 0 21.647371 -10.967083 -0.688726 -4798 1190 4 0 21.307654 -11.566578 -0.059145 -4799 1190 4 0 20.903506 -10.948374 -1.343290 -4800 1191 6 0 -22.639740 18.869062 12.772784 -4801 1191 4 0 -23.598249 18.977251 12.816087 -4802 1191 4 0 -22.528147 18.565590 11.856412 -4803 1192 6 0 -19.354849 19.459324 -20.763860 -4804 1192 4 0 -19.638921 18.619981 -20.405119 -4805 1192 4 0 -19.999366 20.121418 -20.384538 -4806 1193 6 0 -27.292577 17.947849 -7.899480 -4807 1193 4 0 -26.865640 18.369463 -8.665053 -4808 1193 4 0 -26.976583 18.519563 -7.163255 -4809 1194 6 0 -20.817821 -2.868450 14.802525 -4810 1194 4 0 -21.140828 -3.572172 14.242551 -4811 1194 4 0 -21.382527 -2.899729 15.647552 -4812 1195 6 0 -26.483700 3.477220 -8.027358 -4813 1195 4 0 -27.118971 4.203207 -8.001463 -4814 1195 4 0 -25.572543 3.766211 -8.004075 -4815 1196 6 0 -20.066885 -9.761422 6.553470 -4816 1196 4 0 -20.997945 -9.935159 6.946701 -4817 1196 4 0 -19.442249 -9.796491 7.281455 -4818 1197 6 0 -23.097741 6.873436 -18.392975 -4819 1197 4 0 -22.589483 6.725087 -19.200274 -4820 1197 4 0 -22.785797 7.752769 -18.098029 -4821 1198 6 0 18.849536 1.746914 0.846251 -4822 1198 4 0 18.128002 2.129064 0.287715 -4823 1198 4 0 19.181226 2.420341 1.435040 -4824 1199 6 0 27.002887 18.923510 11.873786 -4825 1199 4 0 27.227664 19.764419 11.414163 -4826 1199 4 0 26.105946 19.033421 11.984937 -4827 1200 6 0 -11.158512 11.141322 18.442481 -4828 1200 4 0 -11.408050 10.995491 17.540347 -4829 1200 4 0 -10.502213 10.475024 18.734764 -4830 1201 6 0 -21.495790 -1.351514 -4.237645 -4831 1201 4 0 -21.044359 -1.664515 -3.433502 -4832 1201 4 0 -22.384314 -1.671646 -4.060127 -4833 1202 6 0 15.621755 -15.205139 -2.495677 -4834 1202 4 0 15.424484 -14.934581 -1.611471 -4835 1202 4 0 16.121625 -14.529114 -2.853796 -4836 1203 6 0 4.381992 13.875981 -1.032186 -4837 1203 4 0 5.333475 13.689707 -0.896179 -4838 1203 4 0 4.022732 13.223499 -1.665135 -4839 1204 6 0 20.177887 10.395959 -3.696541 -4840 1204 4 0 20.356404 10.914845 -4.496586 -4841 1204 4 0 20.991017 10.244340 -3.211612 -4842 1205 6 0 15.157815 19.249081 -18.039544 -4843 1205 4 0 15.352336 20.161425 -17.776001 -4844 1205 4 0 15.059841 19.346261 -19.002141 -4845 1206 6 0 -7.108984 -13.295157 15.804846 -4846 1206 4 0 -6.929809 -14.169985 15.496547 -4847 1206 4 0 -6.361874 -13.100921 16.402035 -4848 1207 6 0 -25.065030 -11.005040 18.970744 -4849 1207 4 0 -25.902113 -11.429253 18.763963 -4850 1207 4 0 -25.182957 -10.072508 18.787257 -4851 1208 6 0 11.932413 -6.103636 -13.397989 -4852 1208 4 0 12.570617 -5.775336 -12.776618 -4853 1208 4 0 12.223586 -6.926860 -13.765008 -4854 1209 6 0 -25.022964 -4.047632 -16.421532 -4855 1209 4 0 -24.729550 -4.908790 -16.087160 -4856 1209 4 0 -24.546933 -3.445338 -15.856315 -4857 1210 6 0 -2.351505 -13.799895 -9.640381 -4858 1210 4 0 -2.806266 -13.103621 -10.108151 -4859 1210 4 0 -1.432803 -13.498454 -9.473869 -4860 1211 6 0 -17.970640 -1.824370 11.981061 -4861 1211 4 0 -18.720197 -1.276483 12.154733 -4862 1211 4 0 -17.669382 -2.084512 12.859437 -4863 1212 6 0 16.682335 16.786230 -5.408443 -4864 1212 4 0 15.963934 17.446355 -5.166695 -4865 1212 4 0 16.709036 16.877417 -6.391919 -4866 1213 6 0 -26.984415 4.176614 -3.075863 -4867 1213 4 0 -26.123649 4.345106 -2.684692 -4868 1213 4 0 -26.853761 3.725314 -3.913099 -4869 1214 6 0 -26.077892 0.261300 17.719641 -4870 1214 4 0 -26.784019 0.913023 17.543217 -4871 1214 4 0 -26.472468 -0.574255 17.882963 -4872 1215 6 0 22.927522 20.111945 -15.638008 -4873 1215 4 0 23.596986 20.008343 -14.934189 -4874 1215 4 0 22.343012 20.821690 -15.365852 -4875 1216 6 0 -5.579568 -12.021256 13.421129 -4876 1216 4 0 -5.890589 -11.086014 13.250578 -4877 1216 4 0 -6.303487 -12.389144 13.952477 -4878 1217 6 0 2.458268 -17.079274 7.291369 -4879 1217 4 0 2.320253 -17.365496 8.234460 -4880 1217 4 0 1.770368 -16.394030 7.185697 -4881 1218 6 0 -24.595173 -15.448874 14.340370 -4882 1218 4 0 -23.877774 -15.587584 14.998240 -4883 1218 4 0 -25.176320 -14.635721 14.530870 -4884 1219 6 0 27.032054 -9.403183 3.148273 -4885 1219 4 0 26.403900 -8.794366 3.626157 -4886 1219 4 0 27.383095 -9.993711 3.825592 -4887 1220 6 0 -20.726606 14.795856 1.273133 -4888 1220 4 0 -19.806504 14.435167 1.199972 -4889 1220 4 0 -21.276966 14.325769 0.588346 -4890 1221 6 0 -24.967956 8.541628 1.328681 -4891 1221 4 0 -24.984827 9.452469 1.040896 -4892 1221 4 0 -25.740396 8.434977 1.929151 -4893 1222 6 0 -12.425328 11.518457 -14.199688 -4894 1222 4 0 -12.773966 12.392793 -14.015441 -4895 1222 4 0 -13.118630 10.965584 -13.849575 -4896 1223 6 0 -2.529035 -2.360811 17.836544 -4897 1223 4 0 -3.234696 -2.119216 18.386147 -4898 1223 4 0 -1.867440 -1.729883 18.015495 -4899 1224 6 0 -21.776402 4.919177 -10.291667 -4900 1224 4 0 -22.083924 5.863215 -10.349382 -4901 1224 4 0 -22.101633 4.482076 -11.074994 -4902 1225 6 0 6.293596 15.999990 18.747555 -4903 1225 4 0 5.792274 16.524552 19.421554 -4904 1225 4 0 5.641363 15.346197 18.513974 -4905 1226 6 0 8.520334 14.536496 -17.222476 -4906 1226 4 0 9.367910 14.362425 -16.812169 -4907 1226 4 0 8.183656 13.684606 -17.523424 -4908 1227 6 0 22.691056 10.129741 -9.774947 -4909 1227 4 0 22.388373 10.989892 -9.545078 -4910 1227 4 0 23.520258 10.122274 -10.228776 -4911 1228 6 0 11.292032 2.127043 14.679028 -4912 1228 4 0 10.300438 2.012949 14.574584 -4913 1228 4 0 11.707898 2.382716 13.839204 -4914 1229 6 0 -10.080449 15.590962 -5.638342 -4915 1229 4 0 -9.913581 15.482801 -6.607010 -4916 1229 4 0 -11.000029 15.446049 -5.572110 -4917 1230 6 0 9.724654 19.017882 -10.687275 -4918 1230 4 0 10.589720 19.426462 -10.594122 -4919 1230 4 0 9.112520 19.575919 -10.256988 -4920 1231 6 0 -3.018641 7.588470 16.688095 -4921 1231 4 0 -2.330160 6.909662 16.567035 -4922 1231 4 0 -3.336233 7.572799 15.739189 -4923 1232 6 0 -23.558310 -7.134740 -5.487980 -4924 1232 4 0 -23.265138 -7.142827 -4.583180 -4925 1232 4 0 -23.745933 -6.250685 -5.834602 -4926 1233 6 0 4.226629 15.093702 15.365734 -4927 1233 4 0 4.100578 14.882406 16.320809 -4928 1233 4 0 5.174530 15.177349 15.271261 -4929 1234 6 0 -7.236890 20.676688 -13.887599 -4930 1234 4 0 -7.297460 19.771023 -14.250227 -4931 1234 4 0 -6.598431 21.116314 -14.486914 -4932 1235 6 0 15.815010 1.151652 -17.502222 -4933 1235 4 0 15.282468 0.557615 -16.965425 -4934 1235 4 0 15.054480 1.630363 -17.957554 -4935 1236 6 0 -20.408893 -2.203285 -1.832435 -4936 1236 4 0 -20.785863 -1.600728 -1.206934 -4937 1236 4 0 -20.672903 -3.085785 -1.719471 -4938 1237 6 0 20.195914 -9.732203 -7.503586 -4939 1237 4 0 19.775594 -9.020266 -6.898678 -4940 1237 4 0 21.112065 -9.804356 -7.217365 -4941 1238 6 0 19.296629 -3.381575 11.843745 -4942 1238 4 0 19.274699 -4.314587 11.989050 -4943 1238 4 0 20.065392 -3.074363 12.391528 -4944 1239 6 0 6.531812 13.501627 -15.078637 -4945 1239 4 0 5.967341 14.060209 -15.705952 -4946 1239 4 0 6.508026 12.632112 -15.439267 -4947 1240 6 0 23.589867 -10.343367 -8.571682 -4948 1240 4 0 23.047931 -10.296334 -7.779151 -4949 1240 4 0 23.642788 -11.281031 -8.849406 -4950 1241 6 0 -13.933420 -9.985099 16.210161 -4951 1241 4 0 -13.061691 -9.875550 16.658981 -4952 1241 4 0 -13.656103 -10.632088 15.489463 -4953 1242 6 0 -23.237683 18.866731 19.359260 -4954 1242 4 0 -22.914140 19.726873 19.738290 -4955 1242 4 0 -23.718173 18.429834 20.073905 -4956 1243 6 0 10.494095 4.110524 19.341374 -4957 1243 4 0 9.723154 4.572616 18.942773 -4958 1243 4 0 11.209458 4.339646 18.681127 -4959 1244 6 0 1.369329 -9.441779 19.284078 -4960 1244 4 0 2.015289 -10.186860 19.212218 -4961 1244 4 0 1.015324 -9.189016 18.436693 -4962 1245 6 0 -12.121346 16.858305 -16.912154 -4963 1245 4 0 -12.482071 17.717178 -16.927558 -4964 1245 4 0 -11.557811 16.791147 -17.773819 -4965 1246 6 0 -9.672999 19.181029 4.107845 -4966 1246 4 0 -8.970953 19.839775 3.892751 -4967 1246 4 0 -10.347573 19.719934 4.574402 -4968 1247 6 0 -25.848254 19.893856 -6.158583 -4969 1247 4 0 -26.297371 20.306721 -5.458518 -4970 1247 4 0 -25.747309 20.595741 -6.795744 -4971 1248 6 0 -23.033567 -20.060181 19.659192 -4972 1248 4 0 -22.235177 -19.955724 19.067747 -4973 1248 4 0 -23.368334 -19.148619 19.847979 -4974 1249 6 0 -15.791938 8.271699 18.828418 -4975 1249 4 0 -16.027582 7.356294 18.646313 -4976 1249 4 0 -16.655172 8.767091 18.686291 -4977 1250 6 0 -21.708167 13.277512 -0.641646 -4978 1250 4 0 -22.597047 13.562637 -0.909355 -4979 1250 4 0 -21.809236 12.333829 -0.325507 -4980 1251 6 0 5.941295 -12.360207 -6.112984 -4981 1251 4 0 6.359630 -11.626042 -5.736075 -4982 1251 4 0 6.495648 -12.726477 -6.802834 -4983 1252 6 0 13.032092 -7.701355 -9.994956 -4984 1252 4 0 13.027162 -8.501577 -10.533994 -4985 1252 4 0 12.548921 -8.005933 -9.172971 -4986 1253 6 0 -21.030949 -20.119698 18.010996 -4987 1253 4 0 -20.244199 -20.716690 18.012037 -4988 1253 4 0 -20.696565 -19.252737 17.848450 -4989 1254 6 0 -19.015223 -0.571456 18.155941 -4990 1254 4 0 -19.180719 -0.389583 17.176932 -4991 1254 4 0 -18.385462 0.098617 18.394716 -4992 1255 6 0 -20.138485 -4.252628 -11.316573 -4993 1255 4 0 -19.840849 -5.049159 -11.793063 -4994 1255 4 0 -20.052902 -4.580000 -10.382886 -4995 1256 6 0 26.001968 -7.495414 4.672795 -4996 1256 4 0 25.441451 -7.324776 5.428706 -4997 1256 4 0 26.791498 -7.049997 4.959197 -4998 1257 6 0 19.055181 -8.349517 1.323580 -4999 1257 4 0 19.813936 -8.781204 1.703347 -5000 1257 4 0 19.440205 -7.777422 0.589952 -5001 1258 6 0 25.264798 8.233933 8.591555 -5002 1258 4 0 25.487528 8.137778 9.540405 -5003 1258 4 0 25.431397 9.162412 8.389274 -5004 1259 6 0 12.847916 19.693484 13.048286 -5005 1259 4 0 11.960267 19.995654 12.950099 -5006 1259 4 0 13.352276 20.516003 12.895948 -5007 1260 6 0 -1.639765 11.429914 5.808063 -5008 1260 4 0 -1.143950 12.047063 6.360614 -5009 1260 4 0 -2.350791 11.948090 5.492463 -5010 1261 6 0 9.848758 16.041115 -10.707370 -5011 1261 4 0 9.065082 15.706216 -11.123228 -5012 1261 4 0 9.845269 17.025290 -10.747608 -5013 1262 6 0 25.426954 20.293141 3.300623 -5014 1262 4 0 25.545358 20.769417 4.152492 -5015 1262 4 0 25.632270 21.033287 2.715396 -5016 1263 6 0 20.761109 8.207487 15.638898 -5017 1263 4 0 20.452100 8.556874 16.455577 -5018 1263 4 0 20.418491 7.276974 15.507884 -5019 1264 6 0 -17.340920 8.603213 9.973826 -5020 1264 4 0 -17.013776 7.715227 10.202262 -5021 1264 4 0 -17.708959 8.550775 9.106960 -5022 1265 6 0 -4.331343 4.519352 -17.647753 -5023 1265 4 0 -5.066787 3.870671 -17.637369 -5024 1265 4 0 -3.551869 3.998790 -17.434586 -5025 1266 6 0 20.173773 -17.092486 -7.001341 -5026 1266 4 0 19.888855 -16.443588 -7.714490 -5027 1266 4 0 20.413820 -17.900629 -7.443434 -5028 1267 6 0 -24.408814 -19.385733 11.225815 -5029 1267 4 0 -23.821161 -19.917061 10.749392 -5030 1267 4 0 -23.910074 -18.660169 11.617528 -5031 1268 6 0 17.324633 -1.128975 8.030022 -5032 1268 4 0 17.360905 -1.837044 8.692495 -5033 1268 4 0 18.151746 -0.980682 7.588726 -5034 1269 6 0 23.955106 -0.867756 -15.846487 -5035 1269 4 0 24.366679 -1.312193 -16.592677 -5036 1269 4 0 23.040207 -0.721605 -15.963924 -5037 1270 6 0 9.794322 -16.325238 -14.689703 -5038 1270 4 0 10.077445 -16.942203 -15.418778 -5039 1270 4 0 10.274190 -16.591924 -13.896103 -5040 1271 6 0 -19.734101 -12.095151 -17.153284 -5041 1271 4 0 -20.605684 -12.154989 -17.550952 -5042 1271 4 0 -19.490756 -11.177750 -17.393726 -5043 1272 6 0 2.145542 4.244476 10.559284 -5044 1272 4 0 1.712137 4.346774 11.448612 -5045 1272 4 0 1.552348 4.733416 9.969137 -5046 1273 6 0 -11.816250 3.934419 -18.405990 -5047 1273 4 0 -11.103191 4.038219 -19.027130 -5048 1273 4 0 -12.427642 3.303177 -18.846649 -5049 1274 6 0 18.893576 -19.279190 2.434753 -5050 1274 4 0 19.835933 -19.611541 2.415682 -5051 1274 4 0 18.743093 -19.115267 3.373179 -5052 1275 6 0 20.503855 18.939356 -0.359795 -5053 1275 4 0 20.047818 18.683781 0.506021 -5054 1275 4 0 19.907310 19.650581 -0.623461 -5055 1276 6 0 26.407017 7.546865 -12.797932 -5056 1276 4 0 25.672384 7.104790 -13.280274 -5057 1276 4 0 27.091777 7.777455 -13.451817 -5058 1277 6 0 25.647383 -6.341604 -8.154924 -5059 1277 4 0 26.357304 -5.715813 -8.365206 -5060 1277 4 0 25.997425 -7.137628 -8.663351 -5061 1278 6 0 24.828979 0.493040 8.418984 -5062 1278 4 0 25.575762 0.370102 9.128898 -5063 1278 4 0 24.779810 -0.342584 8.014099 -5064 1279 6 0 17.019067 17.317670 3.445072 -5065 1279 4 0 16.246945 17.951681 3.647617 -5066 1279 4 0 17.118513 16.924515 4.354268 -5067 1280 6 0 -14.811273 -9.813473 19.349487 -5068 1280 4 0 -15.258466 -10.583929 19.669257 -5069 1280 4 0 -14.033228 -10.041012 18.847205 -5070 1281 6 0 23.382015 -15.215511 6.306360 -5071 1281 4 0 24.055596 -14.464366 6.446483 -5072 1281 4 0 22.714188 -14.794741 5.753275 -5073 1282 6 0 -26.337628 -13.401476 1.412480 -5074 1282 4 0 -26.098445 -12.489264 1.304520 -5075 1282 4 0 -25.434229 -13.739613 1.185013 -5076 1283 6 0 12.045641 6.334478 14.034491 -5077 1283 4 0 11.290237 6.052909 13.448299 -5078 1283 4 0 12.782332 5.993917 13.490639 -5079 1284 6 0 20.125812 -8.202150 -9.814098 -5080 1284 4 0 20.194536 -8.887766 -9.162911 -5081 1284 4 0 21.027215 -8.057148 -10.044296 -5082 1285 6 0 12.066525 -8.540938 -7.364209 -5083 1285 4 0 11.508583 -8.030746 -6.799426 -5084 1285 4 0 11.560454 -9.411302 -7.497328 -5085 1286 6 0 6.006584 -19.643391 -16.856771 -5086 1286 4 0 5.834004 -19.490315 -17.723180 -5087 1286 4 0 5.173445 -19.306940 -16.418662 -5088 1287 6 0 -26.105240 9.497668 11.035009 -5089 1287 4 0 -25.940506 10.208588 11.676762 -5090 1287 4 0 -26.907023 9.839249 10.688906 -5091 1288 6 0 25.980779 -10.760099 -17.043079 -5092 1288 4 0 26.294152 -9.947887 -17.408944 -5093 1288 4 0 26.659719 -11.433214 -17.294305 -5094 1289 6 0 17.405056 -19.269747 -14.944723 -5095 1289 4 0 17.214410 -18.409556 -14.434720 -5096 1289 4 0 17.526094 -19.972476 -14.301658 -5097 1290 6 0 -24.018604 17.625199 1.640879 -5098 1290 4 0 -24.784080 17.611175 1.083900 -5099 1290 4 0 -24.038354 18.437262 2.233960 -5100 1291 6 0 -19.713596 9.725034 11.241378 -5101 1291 4 0 -20.334881 9.562447 10.458947 -5102 1291 4 0 -18.859792 9.431551 10.874150 -5103 1292 6 0 12.017227 10.801952 4.275634 -5104 1292 4 0 11.431320 10.637434 5.045035 -5105 1292 4 0 11.407446 10.560420 3.532631 -5106 1293 6 0 -2.032321 -18.778706 7.677870 -5107 1293 4 0 -1.174746 -18.822855 7.226095 -5108 1293 4 0 -2.302104 -17.849324 7.787431 -5109 1294 6 0 27.376193 5.800091 -18.808667 -5110 1294 4 0 28.217784 5.560939 -18.324424 -5111 1294 4 0 27.470430 6.797809 -18.833583 -5112 1295 6 0 22.777052 -4.203723 15.528690 -5113 1295 4 0 22.819825 -4.163457 14.596219 -5114 1295 4 0 23.290333 -4.967303 15.841471 -5115 1296 6 0 -24.407041 -11.771935 -2.162786 -5116 1296 4 0 -24.850114 -12.297116 -2.844402 -5117 1296 4 0 -24.335332 -10.842961 -2.448771 -5118 1297 6 0 26.515383 14.863308 -11.949090 -5119 1297 4 0 25.693505 15.247676 -11.698157 -5120 1297 4 0 27.137639 14.903509 -11.237657 -5121 1298 6 0 9.526170 19.544584 -4.495947 -5122 1298 4 0 8.563440 19.681938 -4.310177 -5123 1298 4 0 9.710873 20.389152 -4.948099 -5124 1299 6 0 0.930640 14.865621 2.693375 -5125 1299 4 0 1.441052 15.216977 2.015262 -5126 1299 4 0 0.982855 15.427541 3.521397 -5127 1300 6 0 -8.560884 -14.779791 -0.317309 -5128 1300 4 0 -7.563132 -14.724309 -0.578447 -5129 1300 4 0 -8.944725 -15.346794 -1.006948 -5130 1301 6 0 -7.319722 -18.863858 -20.528347 -5131 1301 4 0 -8.028502 -18.663258 -21.126375 -5132 1301 4 0 -7.164500 -19.772394 -20.500444 -5133 1302 6 0 -15.128995 -19.691380 3.092730 -5134 1302 4 0 -16.008789 -19.690772 3.472840 -5135 1302 4 0 -14.968322 -20.623238 2.789294 -5136 1303 6 0 14.985700 14.931491 -8.447163 -5137 1303 4 0 15.394555 15.826269 -8.282486 -5138 1303 4 0 14.583931 14.705829 -7.592039 -5139 1304 6 0 27.322481 11.495061 -9.977404 -5140 1304 4 0 26.863175 12.062729 -9.353442 -5141 1304 4 0 28.126888 11.829690 -10.258173 -5142 1305 6 0 -18.229397 7.978168 7.639376 -5143 1305 4 0 -19.028971 7.438874 7.807107 -5144 1305 4 0 -17.575997 7.370338 7.232298 -5145 1306 6 0 -5.554901 9.643950 18.209130 -5146 1306 4 0 -4.877908 10.197790 17.765078 -5147 1306 4 0 -5.709375 10.290933 18.919059 -5148 1307 6 0 27.055810 -8.039157 10.769461 -5149 1307 4 0 27.007722 -8.570107 10.005081 -5150 1307 4 0 26.186325 -7.596689 10.673325 -5151 1308 6 0 11.193144 -4.443017 6.826722 -5152 1308 4 0 10.836891 -3.569010 6.720665 -5153 1308 4 0 12.137206 -4.292318 6.939554 -5154 1309 6 0 19.268222 19.404109 -20.005983 -5155 1309 4 0 18.552307 19.427583 -20.612317 -5156 1309 4 0 20.054546 19.443947 -20.508778 -5157 1310 6 0 -0.489608 2.918279 -19.339493 -5158 1310 4 0 -0.728227 3.023881 -20.237208 -5159 1310 4 0 0.435524 3.253135 -19.140478 -5160 1311 6 0 -9.930055 10.868000 -17.673601 -5161 1311 4 0 -10.626469 11.466271 -17.943644 -5162 1311 4 0 -9.408670 11.199903 -16.908283 -5163 1312 6 0 14.391665 -7.492360 -17.133433 -5164 1312 4 0 14.776095 -6.640715 -16.914336 -5165 1312 4 0 14.844935 -7.826758 -17.919613 -5166 1313 6 0 -4.403090 17.562294 4.304967 -5167 1313 4 0 -3.639926 17.895809 4.788467 -5168 1313 4 0 -4.847822 18.247386 3.881416 -5169 1314 6 0 14.924216 -8.572989 -7.802421 -5170 1314 4 0 15.080791 -9.001730 -8.577899 -5171 1314 4 0 14.072292 -8.888256 -7.443501 -5172 1315 6 0 20.863060 -8.335281 -2.996473 -5173 1315 4 0 20.865038 -7.834818 -2.195694 -5174 1315 4 0 20.360014 -9.121641 -2.844384 -5175 1316 6 0 7.770701 4.749626 -15.173810 -5176 1316 4 0 7.232605 4.918984 -14.407401 -5177 1316 4 0 7.150893 4.735931 -15.889673 -5178 1317 6 0 9.287502 -20.421293 -19.615918 -5179 1317 4 0 8.673901 -19.918813 -20.140368 -5180 1317 4 0 10.257214 -20.289398 -19.904230 -5181 1318 6 0 20.543914 -3.694600 8.858562 -5182 1318 4 0 20.350529 -3.346561 9.790355 -5183 1318 4 0 20.284447 -4.620852 8.950478 -5184 1319 6 0 -24.889469 -2.826087 -11.161559 -5185 1319 4 0 -24.617642 -1.952238 -10.677372 -5186 1319 4 0 -25.879679 -2.907043 -11.066325 -5187 1320 6 0 16.046200 -19.874001 -17.403642 -5188 1320 4 0 16.633402 -19.935906 -18.189298 -5189 1320 4 0 16.556861 -19.594522 -16.612102 -5190 1321 6 0 5.741718 -12.703855 14.460309 -5191 1321 4 0 6.418646 -13.226075 14.848859 -5192 1321 4 0 5.375423 -12.291966 15.251474 -5193 1322 6 0 -26.921124 3.080708 -16.683288 -5194 1322 4 0 -26.349288 3.764354 -17.076383 -5195 1322 4 0 -27.310492 3.610598 -15.940909 -5196 1323 6 0 -9.051861 -12.598891 -10.481740 -5197 1323 4 0 -9.312975 -13.202994 -11.160740 -5198 1323 4 0 -9.863453 -12.002119 -10.435649 -5199 1324 6 0 11.222934 -19.072403 -5.120308 -5200 1324 4 0 10.662322 -18.478568 -5.660022 -5201 1324 4 0 12.014749 -19.325909 -5.638718 -5202 1325 6 0 18.944446 -1.761496 -1.989981 -5203 1325 4 0 19.143872 -2.715939 -1.959282 -5204 1325 4 0 18.884717 -1.422297 -1.082916 -5205 1326 6 0 23.550316 -15.829708 -20.623087 -5206 1326 4 0 22.847013 -15.261005 -20.962532 -5207 1326 4 0 23.291254 -16.269725 -19.776352 -5208 1327 6 0 16.851801 5.388343 15.856452 -5209 1327 4 0 16.397949 5.383405 15.017945 -5210 1327 4 0 16.364224 6.131529 16.215918 -5211 1328 6 0 12.029283 -15.298450 15.005226 -5212 1328 4 0 11.752968 -15.998705 15.556968 -5213 1328 4 0 11.367704 -14.915688 14.430927 -5214 1329 6 0 14.340396 -0.486882 2.372215 -5215 1329 4 0 13.663877 -0.866715 2.885453 -5216 1329 4 0 14.313669 0.446574 2.655905 -5217 1330 6 0 -4.590564 -6.037942 9.321481 -5218 1330 4 0 -4.191484 -6.200341 8.445394 -5219 1330 4 0 -4.057284 -5.373615 9.813704 -5220 1331 6 0 11.373242 -19.244304 -15.042581 -5221 1331 4 0 12.222601 -19.509329 -15.419988 -5222 1331 4 0 10.727440 -19.492586 -15.694712 -5223 1332 6 0 8.445009 -7.353337 -20.644303 -5224 1332 4 0 8.065671 -6.779925 -19.985343 -5225 1332 4 0 8.109658 -8.330016 -20.463794 -5226 1333 6 0 9.428901 8.662531 -17.428301 -5227 1333 4 0 8.456111 8.645724 -17.644511 -5228 1333 4 0 9.529146 9.218358 -16.645571 -5229 1334 6 0 -22.387040 -19.582592 -7.404304 -5230 1334 4 0 -22.537521 -18.739332 -7.873166 -5231 1334 4 0 -22.150442 -19.339940 -6.528223 -5232 1335 6 0 26.735971 -15.726321 7.121648 -5233 1335 4 0 25.953722 -16.106883 7.512069 -5234 1335 4 0 26.460359 -14.804570 6.934323 -5235 1336 6 0 -20.988572 11.929476 3.968066 -5236 1336 4 0 -21.340596 11.563124 4.784938 -5237 1336 4 0 -21.130650 12.884161 4.069043 -5238 1337 6 0 21.473005 20.923952 -4.710755 -5239 1337 4 0 22.324172 21.375208 -4.753044 -5240 1337 4 0 21.707980 20.020307 -4.884522 -5241 1338 6 0 18.479193 -0.888136 0.672743 -5242 1338 4 0 17.536329 -0.750808 0.451811 -5243 1338 4 0 18.753176 -0.016644 0.847545 -5244 1339 6 0 -13.644220 -0.195942 -16.728164 -5245 1339 4 0 -14.145608 -0.971886 -16.514909 -5246 1339 4 0 -13.412704 -0.294150 -17.655379 -5247 1340 6 0 -27.356282 -13.782004 3.934427 -5248 1340 4 0 -27.242980 -13.845896 2.900565 -5249 1340 4 0 -28.015991 -14.339318 4.193014 -5250 1341 6 0 18.276550 10.521821 -10.411508 -5251 1341 4 0 17.466149 10.037966 -10.334512 -5252 1341 4 0 18.135131 11.463023 -10.441937 -5253 1342 6 0 11.304676 -3.958739 14.771873 -5254 1342 4 0 10.819571 -4.657592 14.338362 -5255 1342 4 0 11.872243 -4.302988 15.497743 -5256 1343 6 0 0.810718 18.132291 -14.333312 -5257 1343 4 0 0.190255 17.471051 -14.607576 -5258 1343 4 0 1.665202 17.681600 -14.166677 -5259 1344 6 0 -18.194302 10.734237 20.288216 -5260 1344 4 0 -18.737476 10.008872 20.011140 -5261 1344 4 0 -18.413412 10.870765 21.217524 -5262 1345 6 0 -7.563142 -16.389647 8.034997 -5263 1345 4 0 -7.754897 -16.237987 7.073421 -5264 1345 4 0 -8.386855 -16.715419 8.384876 -5265 1346 6 0 13.912058 -6.782117 15.996328 -5266 1346 4 0 13.180027 -7.276194 16.277557 -5267 1346 4 0 13.861231 -6.438577 15.112401 -5268 1347 6 0 -25.429958 -6.548345 16.184656 -5269 1347 4 0 -24.780220 -7.006450 16.697079 -5270 1347 4 0 -26.340485 -6.934525 16.332424 -5271 1348 6 0 -25.500783 -16.025799 -9.490569 -5272 1348 4 0 -26.164448 -16.158413 -8.820769 -5273 1348 4 0 -25.951236 -16.456932 -10.263221 -5274 1349 6 0 24.124222 2.121712 -16.465144 -5275 1349 4 0 24.497335 2.845246 -17.081218 -5276 1349 4 0 24.792485 1.399163 -16.373949 -5277 1350 6 0 4.547327 -7.471124 19.146289 -5278 1350 4 0 4.354864 -7.322111 18.216109 -5279 1350 4 0 3.632016 -7.470487 19.500477 -5280 1351 6 0 10.120616 17.236092 14.316409 -5281 1351 4 0 10.306027 17.503867 15.195486 -5282 1351 4 0 9.503499 17.802179 13.861569 -5283 1352 6 0 21.443686 -0.137574 -7.240239 -5284 1352 4 0 21.320909 -0.780264 -6.543039 -5285 1352 4 0 20.520021 0.052046 -7.411757 -5286 1353 6 0 -18.828207 -17.795055 12.603944 -5287 1353 4 0 -19.462622 -18.118613 13.289732 -5288 1353 4 0 -19.239011 -18.165303 11.770846 -5289 1354 6 0 -5.408698 18.602640 19.942387 -5290 1354 4 0 -4.940011 19.368098 19.546138 -5291 1354 4 0 -4.701861 17.940803 20.028319 -5292 1355 6 0 1.246630 7.058463 14.491223 -5293 1355 4 0 1.833210 6.855645 13.673367 -5294 1355 4 0 1.409024 6.330352 15.131330 -5295 1356 6 0 12.743100 -19.137500 -10.658143 -5296 1356 4 0 12.731029 -19.861558 -11.325766 -5297 1356 4 0 13.636140 -18.849862 -10.621111 -5298 1357 6 0 8.176227 18.621713 -14.093293 -5299 1357 4 0 8.403415 17.666902 -14.107193 -5300 1357 4 0 8.904018 18.994347 -14.634670 -5301 1358 6 0 -2.850169 -13.873152 15.306117 -5302 1358 4 0 -2.778021 -14.417883 14.515219 -5303 1358 4 0 -2.855607 -12.985119 14.927436 -5304 1359 6 0 -2.292558 -20.012333 10.080992 -5305 1359 4 0 -1.651194 -19.572426 10.625999 -5306 1359 4 0 -2.187742 -19.593458 9.218576 -5307 1360 6 0 22.331247 5.799873 2.670280 -5308 1360 4 0 22.434189 5.666649 3.628261 -5309 1360 4 0 22.776307 5.021312 2.347574 -5310 1361 6 0 15.417762 16.217823 -20.022192 -5311 1361 4 0 14.476316 16.148202 -19.889414 -5312 1361 4 0 15.596696 16.629517 -20.930968 -5313 1362 6 0 -26.290384 -0.615609 -8.011370 -5314 1362 4 0 -26.337180 -1.338819 -7.375398 -5315 1362 4 0 -27.197456 -0.506091 -8.331222 -5316 1363 6 0 9.027104 -10.649673 18.216586 -5317 1363 4 0 9.003116 -9.685060 18.321463 -5318 1363 4 0 8.395635 -11.040516 18.879208 -5319 1364 6 0 20.540085 20.400943 18.176526 -5320 1364 4 0 21.096121 20.661895 18.908831 -5321 1364 4 0 19.896888 21.145098 18.113813 -5322 1365 6 0 -1.026820 14.710767 -4.091506 -5323 1365 4 0 -1.483470 15.499879 -3.851169 -5324 1365 4 0 -1.334746 14.285611 -4.859625 -5325 1366 6 0 -26.089489 15.380454 18.855264 -5326 1366 4 0 -25.115552 15.260124 18.557693 -5327 1366 4 0 -26.107913 15.393677 19.825673 -5328 1367 6 0 2.007574 -16.086893 18.910154 -5329 1367 4 0 2.169938 -15.300051 18.371811 -5330 1367 4 0 1.765349 -16.777501 18.309170 -5331 1368 6 0 -1.731416 -1.209658 -17.616026 -5332 1368 4 0 -1.627324 -2.121913 -17.876677 -5333 1368 4 0 -0.897064 -0.759027 -17.856313 -5334 1369 6 0 -7.458988 -9.905611 -19.067646 -5335 1369 4 0 -7.612323 -9.236466 -18.379766 -5336 1369 4 0 -6.775597 -10.433737 -18.660285 -5337 1370 6 0 24.628885 -15.762187 -8.892475 -5338 1370 4 0 24.465618 -16.362594 -8.154270 -5339 1370 4 0 25.428263 -15.265529 -8.789821 -5340 1371 6 0 21.341678 17.087622 -2.433709 -5341 1371 4 0 22.027154 16.590055 -2.017304 -5342 1371 4 0 20.972791 17.595736 -1.703682 -5343 1372 6 0 11.041731 -1.458544 17.027146 -5344 1372 4 0 11.616990 -0.777488 17.323484 -5345 1372 4 0 11.529032 -2.030322 16.345409 -5346 1373 6 0 20.352182 -20.640448 -2.038220 -5347 1373 4 0 20.706451 -20.927732 -2.854198 -5348 1373 4 0 21.078721 -20.655585 -1.410115 -5349 1374 6 0 2.118915 -12.215325 -19.313844 -5350 1374 4 0 1.412292 -12.890446 -19.223921 -5351 1374 4 0 2.971726 -12.642687 -19.466619 -5352 1375 6 0 -18.234007 -11.608978 -6.453902 -5353 1375 4 0 -18.824060 -11.919205 -5.748304 -5354 1375 4 0 -17.399503 -12.148958 -6.321644 -5355 1376 6 0 12.956287 4.319222 -3.994225 -5356 1376 4 0 12.213046 3.674862 -3.908399 -5357 1376 4 0 12.579678 5.119154 -3.559136 -5358 1377 6 0 -16.653199 5.258818 18.455342 -5359 1377 4 0 -17.496007 5.121615 18.892108 -5360 1377 4 0 -16.041443 5.030868 19.126227 -5361 1378 6 0 10.499124 9.233410 -20.179160 -5362 1378 4 0 10.147585 9.358107 -19.280974 -5363 1378 4 0 11.442853 9.276973 -20.041862 -5364 1379 6 0 0.510441 -0.870953 17.320417 -5365 1379 4 0 1.102755 -1.566191 17.515002 -5366 1379 4 0 0.955429 -0.019852 17.557716 -5367 1380 6 0 4.110276 5.067141 6.431077 -5368 1380 4 0 4.761963 4.437776 6.681941 -5369 1380 4 0 4.337595 5.795548 6.948690 -5370 1381 6 0 11.452671 -16.505838 0.173069 -5371 1381 4 0 11.303683 -15.607972 0.510340 -5372 1381 4 0 12.391250 -16.653982 0.330533 -5373 1382 6 0 7.430077 -20.350208 8.105888 -5374 1382 4 0 7.675587 -20.672677 7.187383 -5375 1382 4 0 8.248925 -20.047358 8.520026 -5376 1383 6 0 -7.400434 16.364237 -16.666884 -5377 1383 4 0 -8.382471 16.160840 -16.727806 -5378 1383 4 0 -7.133812 16.815236 -17.541828 -5379 1384 6 0 -24.060814 19.512535 -2.061658 -5380 1384 4 0 -23.130977 19.418843 -1.893643 -5381 1384 4 0 -24.267554 20.363324 -2.551066 -5382 1385 6 0 20.387077 -17.871252 -2.506384 -5383 1385 4 0 19.459013 -17.739929 -2.640716 -5384 1385 4 0 20.424417 -18.802885 -2.422640 -5385 1386 6 0 -9.102927 -20.662897 -0.744511 -5386 1386 4 0 -8.351458 -20.647416 -0.154773 -5387 1386 4 0 -8.808769 -19.943254 -1.313754 -5388 1387 6 0 -22.416841 -13.711743 -11.454147 -5389 1387 4 0 -22.023904 -14.600414 -11.267420 -5390 1387 4 0 -21.766795 -13.100859 -11.064675 -5391 1388 6 0 18.020659 1.320207 -14.873666 -5392 1388 4 0 17.072103 1.602050 -14.789845 -5393 1388 4 0 18.329426 1.503733 -13.971877 -5394 1389 6 0 -15.611967 -16.933927 -20.034244 -5395 1389 4 0 -15.697544 -15.974880 -19.912529 -5396 1389 4 0 -16.463764 -17.241305 -19.666078 -5397 1390 6 0 -21.399563 -20.604313 -19.819242 -5398 1390 4 0 -22.286272 -20.451053 -20.149900 -5399 1390 4 0 -20.960242 -19.767241 -20.062136 -5400 1391 6 0 -14.873799 15.000585 15.755334 -5401 1391 4 0 -15.665375 14.566463 15.276438 -5402 1391 4 0 -15.221469 15.704608 16.223975 -5403 1392 6 0 -22.283717 17.924070 6.363117 -5404 1392 4 0 -22.326943 17.328611 7.088360 -5405 1392 4 0 -22.769780 17.540247 5.616208 -5406 1393 6 0 -4.518256 15.930815 -10.776370 -5407 1393 4 0 -3.722298 16.148281 -11.175263 -5408 1393 4 0 -4.440115 15.005875 -10.441712 -5409 1394 6 0 23.829242 -12.577808 -10.269253 -5410 1394 4 0 23.709620 -12.211859 -11.148216 -5411 1394 4 0 24.681269 -13.072156 -10.250620 -5412 1395 6 0 25.052401 -0.262291 -3.629356 -5413 1395 4 0 25.651051 -0.543026 -4.364585 -5414 1395 4 0 24.527612 0.474703 -4.021632 -5415 1396 6 0 14.329934 -16.440730 7.995977 -5416 1396 4 0 15.030052 -16.157725 7.466301 -5417 1396 4 0 13.674876 -16.863377 7.389073 -5418 1397 6 0 17.211657 20.746652 5.342912 -5419 1397 4 0 17.565761 20.264477 4.651199 -5420 1397 4 0 17.675222 21.576262 5.214762 -5421 1398 6 0 18.857835 10.961021 -18.198746 -5422 1398 4 0 18.582121 10.331224 -18.896135 -5423 1398 4 0 18.706900 11.843177 -18.451427 -5424 1399 6 0 7.806576 -0.529506 11.040094 -5425 1399 4 0 8.004288 -1.400200 11.405855 -5426 1399 4 0 8.516912 0.066000 11.339425 -5427 1400 6 0 -6.293411 -18.726760 -7.845237 -5428 1400 4 0 -6.910802 -18.996812 -8.589964 -5429 1400 4 0 -5.423066 -18.680010 -8.240732 -5430 1401 6 0 -1.265386 -18.351217 15.342196 -5431 1401 4 0 -0.978536 -17.941389 14.498149 -5432 1401 4 0 -1.776754 -19.060650 14.957444 -5433 1402 6 0 22.240898 5.630349 9.837319 -5434 1402 4 0 21.800731 4.901204 9.365178 -5435 1402 4 0 22.570414 6.163537 9.075972 -5436 1403 6 0 -21.322343 8.388055 9.072770 -5437 1403 4 0 -22.042357 8.964988 9.320991 -5438 1403 4 0 -21.568690 8.084477 8.201200 -5439 1404 6 0 -7.671244 -4.189475 20.344117 -5440 1404 4 0 -7.419567 -4.322104 19.418696 -5441 1404 4 0 -8.363860 -4.824728 20.370282 -5442 1405 6 0 -24.129456 16.739076 10.610161 -5443 1405 4 0 -24.547205 17.167468 11.404792 -5444 1405 4 0 -24.468711 15.757636 10.582819 -5445 1406 6 0 -6.867333 -14.186985 10.119152 -5446 1406 4 0 -6.049023 -14.321450 10.601875 -5447 1406 4 0 -7.023306 -14.804381 9.421465 -5448 1407 6 0 27.346506 -3.270333 -16.312802 -5449 1407 4 0 28.255175 -3.592935 -16.275175 -5450 1407 4 0 27.317511 -2.474622 -16.807450 -5451 1408 6 0 -21.641506 5.727852 -20.459813 -5452 1408 4 0 -22.279373 6.214532 -21.053396 -5453 1408 4 0 -20.775787 6.025886 -20.684218 -5454 1409 6 0 25.309710 5.144361 4.524619 -5455 1409 4 0 25.816635 5.036211 5.343240 -5456 1409 4 0 24.410878 4.895458 4.808645 -5457 1410 6 0 -14.509617 -6.262805 19.159506 -5458 1410 4 0 -14.342716 -6.722944 19.988985 -5459 1410 4 0 -14.602416 -5.323286 19.288859 -5460 1411 6 0 -5.343448 -11.274271 19.025798 -5461 1411 4 0 -4.940638 -11.918950 18.424498 -5462 1411 4 0 -5.498793 -11.715720 19.830266 -5463 1412 6 0 -12.848588 -13.590248 17.033609 -5464 1412 4 0 -13.088575 -13.796556 16.123304 -5465 1412 4 0 -11.991420 -14.074390 17.232742 -5466 1413 6 0 -7.289082 -17.381003 -5.549847 -5467 1413 4 0 -8.038865 -17.962440 -5.504293 -5468 1413 4 0 -6.970028 -17.592513 -6.445260 -5469 1414 6 0 19.348721 -14.932661 19.813219 -5470 1414 4 0 19.577232 -15.858745 19.765206 -5471 1414 4 0 18.713188 -14.720751 20.514547 -5472 1415 6 0 -7.930616 -15.106164 -4.397641 -5473 1415 4 0 -8.445836 -14.519877 -4.885728 -5474 1415 4 0 -7.532499 -15.797439 -4.932460 -5475 1416 6 0 9.305997 -17.229888 -1.625877 -5476 1416 4 0 9.781891 -17.999835 -2.038321 -5477 1416 4 0 10.027236 -16.701835 -1.179404 -5478 1417 6 0 14.485547 17.913855 14.273541 -5479 1417 4 0 13.775573 18.190913 13.687091 -5480 1417 4 0 15.292649 17.853242 13.696917 -5481 1418 6 0 -17.856749 -3.239166 18.728922 -5482 1418 4 0 -18.264266 -2.371813 18.585117 -5483 1418 4 0 -17.320266 -3.326693 17.906655 -5484 1419 6 0 11.415319 5.923359 -20.462324 -5485 1419 4 0 12.034713 5.464442 -19.848871 -5486 1419 4 0 10.982818 5.221175 -20.955049 -5487 1420 6 0 4.246715 -11.198844 16.227140 -5488 1420 4 0 4.054406 -10.449224 15.720401 -5489 1420 4 0 3.729643 -11.076561 16.998845 -5490 1421 6 0 17.668887 16.010513 -14.839435 -5491 1421 4 0 17.475048 15.032227 -14.810123 -5492 1421 4 0 17.201356 16.387530 -15.640949 -5493 1422 6 0 -18.492111 8.644500 -1.484673 -5494 1422 4 0 -18.325091 9.560921 -1.252627 -5495 1422 4 0 -19.325787 8.367546 -1.121513 -5496 1423 6 0 13.610401 12.947630 3.013371 -5497 1423 4 0 13.281039 12.533993 3.856655 -5498 1423 4 0 14.367204 13.456810 3.354976 -5499 1424 6 0 -16.423725 20.151070 -20.282392 -5500 1424 4 0 -15.764964 20.343494 -20.952998 -5501 1424 4 0 -17.250142 20.198658 -20.732026 -5502 1425 6 0 -3.989847 10.270724 -11.073966 -5503 1425 4 0 -3.495466 11.034119 -11.283995 -5504 1425 4 0 -4.624991 10.165649 -11.788271 -5505 1426 6 0 16.276806 2.440391 -0.575792 -5506 1426 4 0 15.765940 1.689695 -0.443195 -5507 1426 4 0 16.230870 2.461846 -1.548388 -5508 1427 6 0 16.582337 4.961920 -0.018366 -5509 1427 4 0 16.750405 4.953804 0.881833 -5510 1427 4 0 16.382476 4.092139 -0.296219 -5511 1428 6 0 -16.776801 -4.258809 -20.926631 -5512 1428 4 0 -16.876778 -3.694234 -21.711494 -5513 1428 4 0 -15.815010 -4.231038 -20.634779 -5514 1429 6 0 27.306315 1.909319 15.774251 -5515 1429 4 0 27.528797 1.213633 15.174474 -5516 1429 4 0 26.309168 1.894233 15.827646 -5517 1430 6 0 -25.977063 12.434586 -4.101907 -5518 1430 4 0 -25.419677 13.227991 -4.057872 -5519 1430 4 0 -25.558038 11.886611 -3.392245 -5520 1431 6 0 -8.917537 20.162429 18.906910 -5521 1431 4 0 -9.817722 20.516050 18.889155 -5522 1431 4 0 -8.402992 20.765622 18.322054 -5523 1432 6 0 2.036338 -3.225452 18.493289 -5524 1432 4 0 2.815627 -3.223614 19.047224 -5525 1432 4 0 1.451253 -3.554309 19.176609 -5526 1433 6 0 -10.943111 -16.939296 -15.943963 -5527 1433 4 0 -10.715338 -17.873691 -15.814810 -5528 1433 4 0 -11.411581 -16.839878 -16.774067 -5529 1434 6 0 5.983465 -15.296272 4.531445 -5530 1434 4 0 6.553908 -14.747320 5.130885 -5531 1434 4 0 6.297291 -16.216179 4.672680 -5532 1435 6 0 0.087877 -18.701863 10.933978 -5533 1435 4 0 0.685292 -18.178478 10.372593 -5534 1435 4 0 0.721975 -19.147274 11.528158 -5535 1436 6 0 -15.867197 20.628171 12.879631 -5536 1436 4 0 -14.941749 20.909539 13.127416 -5537 1436 4 0 -16.061214 21.005786 12.011063 -5538 1437 6 0 -15.031464 -1.955849 18.854814 -5539 1437 4 0 -15.381408 -1.375187 18.132775 -5540 1437 4 0 -15.567308 -1.774457 19.596007 -5541 1438 6 0 -5.713639 -18.898958 -11.393727 -5542 1438 4 0 -5.561092 -18.122829 -11.901780 -5543 1438 4 0 -5.027945 -19.039448 -10.715374 -5544 1439 6 0 10.351785 2.342628 9.137608 -5545 1439 4 0 10.219354 1.517524 8.764529 -5546 1439 4 0 9.579584 2.957546 9.024779 -5547 1440 6 0 9.614533 -0.976089 19.746830 -5548 1440 4 0 9.631955 -1.223467 18.785924 -5549 1440 4 0 10.037560 -1.819567 20.145752 -5550 1441 6 0 -25.737514 5.101092 17.496072 -5551 1441 4 0 -25.949189 4.771339 16.619275 -5552 1441 4 0 -25.460497 6.029342 17.333464 -5553 1442 6 0 27.098530 15.410179 3.235558 -5554 1442 4 0 27.365221 16.280617 3.273489 -5555 1442 4 0 27.777628 14.851248 3.682250 -5556 1443 6 0 -22.145578 -2.524811 -16.789026 -5557 1443 4 0 -22.476890 -1.687774 -16.973175 -5558 1443 4 0 -22.545487 -2.678464 -15.881093 -5559 1444 6 0 -20.038660 7.882073 -10.677168 -5560 1444 4 0 -20.786353 8.456789 -10.411968 -5561 1444 4 0 -20.303885 6.997195 -10.661212 -5562 1445 6 0 6.124673 -5.149502 -15.761404 -5563 1445 4 0 6.612667 -4.434874 -15.249053 -5564 1445 4 0 6.646658 -5.246066 -16.553355 -5565 1446 6 0 6.017362 -16.085801 -17.806752 -5566 1446 4 0 6.270539 -16.458116 -16.921098 -5567 1446 4 0 5.250388 -15.542937 -17.506389 -5568 1447 6 0 -9.374031 -17.523242 2.545572 -5569 1447 4 0 -8.487532 -17.678151 2.185352 -5570 1447 4 0 -9.361698 -17.695772 3.484410 -5571 1448 6 0 15.510564 11.705332 -9.223052 -5572 1448 4 0 15.764354 12.551003 -8.768718 -5573 1448 4 0 14.956013 11.971918 -9.941944 -5574 1449 6 0 -8.575937 17.703676 -4.431665 -5575 1449 4 0 -8.405924 17.883222 -3.539392 -5576 1449 4 0 -8.969679 16.778001 -4.495229 -5577 1450 6 0 -15.277037 20.916980 18.527990 -5578 1450 4 0 -14.557049 20.578200 18.029786 -5579 1450 4 0 -14.784644 21.516499 19.154300 -5580 1451 6 0 23.805081 -13.876618 -5.245218 -5581 1451 4 0 23.301003 -14.539959 -4.743943 -5582 1451 4 0 23.699048 -13.156658 -4.566103 -5583 1452 6 0 23.235009 0.659798 -11.019427 -5584 1452 4 0 23.356235 -0.020938 -10.331928 -5585 1452 4 0 23.922180 0.433479 -11.687400 -5586 1453 6 0 -17.846164 6.890268 -13.615475 -5587 1453 4 0 -18.227474 6.233852 -12.960353 -5588 1453 4 0 -17.502560 7.653333 -13.062645 -5589 1454 6 0 3.237690 6.611110 12.384611 -5590 1454 4 0 2.939622 6.791701 11.472608 -5591 1454 4 0 3.597050 5.706217 12.314107 -5592 1455 6 0 12.621261 19.151311 -10.788464 -5593 1455 4 0 12.568861 18.191071 -10.482080 -5594 1455 4 0 12.304890 19.095240 -11.710548 -5595 1456 6 0 15.189541 -3.590616 -0.359174 -5596 1456 4 0 15.402717 -3.225037 -1.223302 -5597 1456 4 0 15.977001 -4.068104 -0.090059 -5598 1457 6 0 -5.355594 -8.568333 19.641427 -5599 1457 4 0 -6.310615 -8.510356 19.969721 -5600 1457 4 0 -5.329970 -9.512642 19.277800 -5601 1458 6 0 6.365722 2.783749 -12.009649 -5602 1458 4 0 6.365749 3.750417 -12.183807 -5603 1458 4 0 5.965929 2.688579 -11.148102 -5604 1459 6 0 13.169614 -10.142007 -11.634557 -5605 1459 4 0 12.793149 -9.899166 -12.523960 -5606 1459 4 0 12.998542 -11.088881 -11.478349 -5607 1460 6 0 -22.674956 -9.666699 -16.999652 -5608 1460 4 0 -22.331812 -10.389941 -17.591652 -5609 1460 4 0 -22.299353 -8.906035 -17.478779 -5610 1461 6 0 -12.989714 14.562837 -4.489024 -5611 1461 4 0 -13.895012 14.141511 -4.581855 -5612 1461 4 0 -12.287469 13.906583 -4.558336 -5613 1462 6 0 11.889244 7.234465 -14.239933 -5614 1462 4 0 11.841540 6.403022 -13.699089 -5615 1462 4 0 11.297036 7.163549 -15.011709 -5616 1463 6 0 14.205425 -4.375072 6.885349 -5617 1463 4 0 14.444785 -3.467494 6.828421 -5618 1463 4 0 14.540396 -4.824463 6.047265 -5619 1464 6 0 14.238877 -11.199937 -5.844240 -5620 1464 4 0 14.336897 -11.151845 -6.791045 -5621 1464 4 0 14.161965 -12.124432 -5.730368 -5622 1465 6 0 16.419881 -8.263494 5.499713 -5623 1465 4 0 16.888087 -7.438031 5.380531 -5624 1465 4 0 16.938306 -8.794006 4.823282 -5625 1466 6 0 23.034740 17.150944 7.848428 -5626 1466 4 0 22.252785 17.491282 7.376162 -5627 1466 4 0 23.353461 18.012155 8.262400 -5628 1467 6 0 -3.250988 20.899767 -14.198279 -5629 1467 4 0 -3.536111 20.593819 -13.311678 -5630 1467 4 0 -2.238291 20.969313 -14.122183 -5631 1468 6 0 2.193864 -14.308738 -13.102332 -5632 1468 4 0 2.901120 -13.646677 -13.123464 -5633 1468 4 0 2.577942 -14.916050 -13.753214 -5634 1469 6 0 17.220878 14.344503 7.704982 -5635 1469 4 0 16.741444 14.217801 8.575501 -5636 1469 4 0 17.724190 13.489371 7.542738 -5637 1470 6 0 12.455324 8.941935 14.709279 -5638 1470 4 0 12.329532 7.965607 14.651692 -5639 1470 4 0 13.090154 8.950686 15.466000 -5640 1471 6 0 -12.573656 -3.849306 9.754915 -5641 1471 4 0 -11.774505 -4.059630 10.198532 -5642 1471 4 0 -13.177238 -3.385101 10.384533 -5643 1472 6 0 -3.160920 -11.557605 -13.637501 -5644 1472 4 0 -3.513108 -10.729378 -13.902906 -5645 1472 4 0 -2.423129 -11.640209 -14.202523 -5646 1473 6 0 0.173291 18.530627 4.588870 -5647 1473 4 0 0.366643 18.095665 3.775805 -5648 1473 4 0 0.528197 17.966406 5.256043 -5649 1474 6 0 -20.835824 0.618182 3.010345 -5650 1474 4 0 -21.714394 0.910710 2.556806 -5651 1474 4 0 -20.176134 1.018899 2.465288 -5652 1475 6 0 -5.819679 17.244537 -18.746988 -5653 1475 4 0 -4.895225 17.522561 -18.912967 -5654 1475 4 0 -5.875069 16.339088 -19.152521 -5655 1476 6 0 23.150756 6.504841 -18.289508 -5656 1476 4 0 23.185422 7.145655 -19.092606 -5657 1476 4 0 22.256620 6.278150 -18.023232 -5658 1477 6 0 11.077729 -17.823438 -12.637425 -5659 1477 4 0 11.305129 -18.418523 -13.399570 -5660 1477 4 0 11.718877 -18.045413 -11.962474 -5661 1478 6 0 -18.440076 4.089219 -20.233130 -5662 1478 4 0 -18.592368 4.508225 -19.389005 -5663 1478 4 0 -18.684565 4.808320 -20.850382 -5664 1479 6 0 -23.687711 -16.266769 -17.315735 -5665 1479 4 0 -23.698996 -15.631059 -16.558060 -5666 1479 4 0 -22.895860 -16.803598 -17.114489 -5667 1480 6 0 -12.383477 -18.880969 14.766217 -5668 1480 4 0 -12.124554 -18.562567 13.876588 -5669 1480 4 0 -11.797092 -18.625014 15.425543 -5670 1481 6 0 14.311125 11.668895 8.886321 -5671 1481 4 0 13.349519 11.381714 8.877659 -5672 1481 4 0 14.742001 11.037775 8.253125 -5673 1482 6 0 21.499156 2.133932 3.402465 -5674 1482 4 0 22.423113 2.229631 3.696856 -5675 1482 4 0 21.472059 1.349459 2.811378 -5676 1483 6 0 22.466695 -14.225899 -2.830703 -5677 1483 4 0 22.948700 -13.678947 -2.237715 -5678 1483 4 0 22.233121 -15.024736 -2.381007 -5679 1484 6 0 -17.714836 -8.402483 -11.856647 -5680 1484 4 0 -18.457906 -8.997855 -11.616200 -5681 1484 4 0 -16.950883 -8.800780 -11.389594 -5682 1485 6 0 -13.154395 20.875531 -1.901594 -5683 1485 4 0 -14.099007 20.684326 -1.676218 -5684 1485 4 0 -12.776951 21.273644 -1.137151 -5685 1486 6 0 10.058528 -10.804893 -19.659672 -5686 1486 4 0 10.024212 -10.944820 -18.690131 -5687 1486 4 0 9.262507 -10.364334 -19.857371 -5688 1487 6 0 24.206149 -6.530273 6.651758 -5689 1487 4 0 23.298132 -6.779979 6.469418 -5690 1487 4 0 24.435964 -6.280937 7.532499 -5691 1488 6 0 -0.769539 13.370711 18.754750 -5692 1488 4 0 -1.399471 13.295369 18.002641 -5693 1488 4 0 -1.282846 13.503163 19.578024 -5694 1489 6 0 12.489489 -16.824385 17.447916 -5695 1489 4 0 12.052693 -16.106503 17.961272 -5696 1489 4 0 12.979700 -17.322750 18.119196 -5697 1490 6 0 22.391449 -7.947848 18.889943 -5698 1490 4 0 22.777744 -7.558109 18.080179 -5699 1490 4 0 21.582771 -8.396208 18.531967 -5700 1491 6 0 24.444175 12.917036 5.832052 -5701 1491 4 0 24.511172 13.835523 6.045623 -5702 1491 4 0 23.797849 12.920835 5.128292 -5703 1492 6 0 13.404469 11.238393 -13.308046 -5704 1492 4 0 13.712479 10.420163 -13.763288 -5705 1492 4 0 12.688252 10.856036 -12.768343 -5706 1493 6 0 20.968072 -7.216860 -20.774585 -5707 1493 4 0 21.500932 -6.797898 -20.085206 -5708 1493 4 0 21.506305 -7.089210 -21.583804 -5709 1494 6 0 -17.856365 -7.389334 -15.755928 -5710 1494 4 0 -17.779099 -7.695814 -16.681187 -5711 1494 4 0 -17.454778 -6.543622 -15.646073 -5712 1495 6 0 -5.627767 -14.791821 -18.435422 -5713 1495 4 0 -6.515410 -14.559760 -18.598093 -5714 1495 4 0 -5.318446 -15.164242 -19.264852 -5715 1496 6 0 2.656405 -0.176950 -14.262302 -5716 1496 4 0 2.534896 -0.323212 -15.231477 -5717 1496 4 0 3.447328 0.360291 -14.052654 -5718 1497 6 0 -26.736151 5.658653 0.855763 -5719 1497 4 0 -25.877403 5.925247 0.635025 -5720 1497 4 0 -26.753355 4.689074 0.832778 -5721 1498 6 0 -8.652434 19.947608 -11.265190 -5722 1498 4 0 -8.042720 19.800388 -11.992106 -5723 1498 4 0 -8.377500 20.767189 -10.778181 -5724 1499 6 0 3.645772 -16.139913 -20.354692 -5725 1499 4 0 3.723824 -17.050742 -20.075710 -5726 1499 4 0 3.139128 -16.051183 -21.192748 -5727 1500 6 0 2.751218 19.096756 -12.278055 -5728 1500 4 0 3.589100 18.687062 -12.053483 -5729 1500 4 0 2.907368 19.432717 -13.149786 -5730 1501 6 0 11.895340 -6.132227 -17.645418 -5731 1501 4 0 12.272195 -6.990163 -17.614612 -5732 1501 4 0 12.522919 -5.533948 -18.055179 -5733 1502 6 0 -2.649062 -11.532506 14.303842 -5734 1502 4 0 -2.171418 -10.788172 14.727655 -5735 1502 4 0 -3.444108 -11.118837 14.016513 -5736 1503 6 0 0.083662 -17.539610 -9.794080 -5737 1503 4 0 0.925887 -17.184555 -10.098352 -5738 1503 4 0 0.064605 -17.230344 -8.891803 -5739 1504 6 0 -23.495878 -18.174487 -3.096140 -5740 1504 4 0 -23.397765 -18.550076 -2.214521 -5741 1504 4 0 -23.991094 -18.883389 -3.445375 -5742 1505 6 0 -2.870665 -20.299637 3.495989 -5743 1505 4 0 -2.025936 -20.316623 2.990845 -5744 1505 4 0 -2.887489 -19.480343 3.955086 -5745 1506 6 0 -23.237675 -7.968838 11.601659 -5746 1506 4 0 -23.646989 -7.664067 12.406714 -5747 1506 4 0 -22.916603 -8.875240 11.799352 -5748 1507 6 0 7.034857 17.671926 16.668461 -5749 1507 4 0 6.910916 17.021535 17.353714 -5750 1507 4 0 7.298259 17.003434 15.931912 -5751 1508 6 0 -3.135847 -0.037211 -19.720235 -5752 1508 4 0 -2.687204 -0.465713 -19.004635 -5753 1508 4 0 -3.883189 -0.596483 -19.830762 -5754 1509 6 0 -4.116282 9.933467 -15.972432 -5755 1509 4 0 -4.382486 10.098448 -16.874934 -5756 1509 4 0 -3.276586 10.322141 -15.857331 -5757 1510 6 0 9.001776 -2.037724 13.845066 -5758 1510 4 0 9.557925 -2.591779 14.385639 -5759 1510 4 0 8.707709 -2.619965 13.087293 -5760 1511 6 0 -14.291358 -16.357375 0.136544 -5761 1511 4 0 -14.623350 -16.546154 1.040530 -5762 1511 4 0 -13.337866 -16.185545 0.296606 -5763 1512 6 0 -8.307685 7.831957 -19.053875 -5764 1512 4 0 -8.711204 7.493084 -18.235703 -5765 1512 4 0 -7.891044 8.658915 -18.717398 -5766 1513 6 0 20.987462 12.906787 9.958048 -5767 1513 4 0 21.435148 12.305385 10.516693 -5768 1513 4 0 21.330938 12.746483 9.110616 -5769 1514 6 0 24.845310 0.514421 -13.306188 -5770 1514 4 0 24.715007 0.071792 -14.155230 -5771 1514 4 0 25.044193 1.459969 -13.507156 -5772 1515 6 0 9.940414 -19.224463 8.285169 -5773 1515 4 0 10.344194 -19.951358 7.833443 -5774 1515 4 0 9.604359 -18.739761 7.480563 -5775 1516 6 0 -21.714063 9.254293 -18.084261 -5776 1516 4 0 -21.666348 10.112348 -18.429358 -5777 1516 4 0 -20.881272 8.819770 -18.352190 -5778 1517 6 0 -7.191585 20.361392 -7.614111 -5779 1517 4 0 -7.827974 20.909525 -8.157675 -5780 1517 4 0 -7.763622 19.592347 -7.497909 -5781 1518 6 0 7.492921 13.497090 -0.820023 -5782 1518 4 0 7.499014 13.132441 -1.738485 -5783 1518 4 0 8.327452 13.163732 -0.446731 -5784 1519 6 0 9.961122 -18.299786 1.611143 -5785 1519 4 0 10.342232 -17.763270 0.893187 -5786 1519 4 0 9.632169 -19.079234 1.161105 -5787 1520 6 0 27.327916 14.167474 11.338410 -5788 1520 4 0 27.056501 14.797382 10.658423 -5789 1520 4 0 26.973899 14.521349 12.195671 -5790 1521 6 0 25.841592 -10.137073 17.886653 -5791 1521 4 0 26.549845 -10.744837 17.581594 -5792 1521 4 0 26.136382 -9.297891 18.115726 -5793 1522 6 0 -26.484582 -7.570640 0.220618 -5794 1522 4 0 -25.957551 -8.034324 0.885908 -5795 1522 4 0 -27.278989 -8.010770 0.092994 -5796 1523 6 0 -15.507886 -14.234567 -19.185887 -5797 1523 4 0 -16.428047 -14.062315 -19.146906 -5798 1523 4 0 -15.141693 -13.449414 -19.706261 -5799 1524 6 0 19.398920 -6.403154 -4.265132 -5800 1524 4 0 18.793855 -6.981438 -4.692992 -5801 1524 4 0 20.078652 -7.004436 -3.840081 -5802 1525 6 0 -14.727762 -11.689529 10.739544 -5803 1525 4 0 -15.118028 -11.677285 11.572442 -5804 1525 4 0 -15.363496 -11.211251 10.219303 -5805 1526 6 0 -10.164834 -13.429658 -5.821471 -5806 1526 4 0 -10.898604 -13.964191 -5.277591 -5807 1526 4 0 -10.251403 -12.561784 -5.414595 -5808 1527 6 0 17.930460 13.937399 -7.632026 -5809 1527 4 0 17.350338 14.712619 -7.873504 -5810 1527 4 0 17.573194 13.449935 -6.914302 -5811 1528 6 0 22.771963 11.789723 -15.991841 -5812 1528 4 0 22.407892 10.960756 -15.803516 -5813 1528 4 0 23.728244 11.844157 -15.970852 -5814 1529 6 0 -27.022171 -9.935535 -1.551898 -5815 1529 4 0 -26.648537 -9.163079 -1.958000 -5816 1529 4 0 -27.147733 -10.561946 -2.264608 -5817 1530 6 0 -25.271131 5.141749 -12.209736 -5818 1530 4 0 -25.693109 5.472145 -11.442865 -5819 1530 4 0 -24.406635 4.695966 -11.908321 -5820 1531 6 0 3.108121 -20.428019 2.767972 -5821 1531 4 0 2.883888 -19.516039 2.682074 -5822 1531 4 0 2.524652 -20.911289 2.151071 -5823 1532 6 0 13.645477 -11.248379 -2.168699 -5824 1532 4 0 14.495812 -10.982395 -1.919860 -5825 1532 4 0 13.602764 -10.946321 -3.131943 -5826 1533 6 0 -15.802101 -18.826697 -13.646876 -5827 1533 4 0 -15.629728 -18.718460 -14.634045 -5828 1533 4 0 -16.312937 -19.607220 -13.527508 -5829 1534 6 0 16.994190 -18.162501 0.782551 -5830 1534 4 0 16.183512 -18.419341 1.225144 -5831 1534 4 0 17.692383 -18.785460 1.112617 -5832 1535 6 0 0.346250 -8.244458 13.026523 -5833 1535 4 0 -0.056728 -8.794215 13.707605 -5834 1535 4 0 0.196186 -7.378794 13.513605 -5835 1536 6 0 -5.876633 -1.250758 16.950150 -5836 1536 4 0 -5.897139 -0.851532 16.048115 -5837 1536 4 0 -6.813697 -1.215101 17.207829 -5838 1537 6 0 -2.852852 -1.916845 15.179008 -5839 1537 4 0 -3.068812 -1.830206 16.106831 -5840 1537 4 0 -3.640384 -2.245054 14.797756 -5841 1538 6 0 -25.940841 -4.816621 -4.070316 -5842 1538 4 0 -25.207622 -5.264430 -3.620016 -5843 1538 4 0 -26.649933 -4.717697 -3.451686 -5844 1539 6 0 4.874827 1.473886 -14.337797 -5845 1539 4 0 5.189548 1.046518 -15.146140 -5846 1539 4 0 5.658759 1.677209 -13.804635 -5847 1540 6 0 -11.399492 -17.545168 -11.709535 -5848 1540 4 0 -10.632696 -17.968067 -12.065761 -5849 1540 4 0 -11.990484 -18.281339 -11.463174 -5850 1541 6 0 -21.235393 3.531686 -18.981903 -5851 1541 4 0 -20.811243 2.725219 -19.355158 -5852 1541 4 0 -21.330003 4.199180 -19.707403 -5853 1542 6 0 19.884738 13.457886 -16.503712 -5854 1542 4 0 20.546443 14.081854 -16.252605 -5855 1542 4 0 19.863325 12.725299 -15.889148 -5856 1543 6 0 -7.613490 -18.734979 -2.286157 -5857 1543 4 0 -7.224353 -19.383742 -2.870642 -5858 1543 4 0 -7.258594 -17.884019 -2.571812 -5859 1544 6 0 20.179247 18.669512 -9.520770 -5860 1544 4 0 19.745104 19.383705 -9.949059 -5861 1544 4 0 21.106271 18.888549 -9.619590 -5862 1545 6 0 0.469489 5.800556 -16.240608 -5863 1545 4 0 0.192512 6.630216 -16.696807 -5864 1545 4 0 0.599388 6.155641 -15.380452 -5865 1546 6 0 6.877961 19.550178 -9.988757 -5866 1546 4 0 6.368993 19.971864 -9.244013 -5867 1546 4 0 6.518231 19.965222 -10.851986 -5868 1547 6 0 6.720059 20.276251 -3.381777 -5869 1547 4 0 5.891426 20.783054 -3.333942 -5870 1547 4 0 6.919774 20.067477 -2.473444 -5871 1548 6 0 22.013148 -15.969229 12.266907 -5872 1548 4 0 21.416898 -16.484884 11.623216 -5873 1548 4 0 22.857478 -16.358079 12.000305 -5874 1549 6 0 -15.694438 7.944675 2.647767 -5875 1549 4 0 -15.370792 7.967212 3.559417 -5876 1549 4 0 -15.467715 7.066496 2.332465 -5877 1550 6 0 -25.016666 -19.872056 -7.507112 -5878 1550 4 0 -24.041389 -19.998563 -7.476847 -5879 1550 4 0 -25.261819 -19.677629 -8.458935 -5880 1551 6 0 -17.404966 16.289559 0.378862 -5881 1551 4 0 -17.816202 15.395796 0.469359 -5882 1551 4 0 -16.592061 16.078371 -0.128857 -5883 1552 6 0 11.719854 13.896915 -20.007550 -5884 1552 4 0 11.762017 13.509054 -20.946443 -5885 1552 4 0 11.730057 13.211150 -19.340581 -5886 1553 6 0 -21.635289 10.922735 -14.289364 -5887 1553 4 0 -22.250180 11.585121 -14.648600 -5888 1553 4 0 -20.920683 10.786571 -14.961527 -5889 1554 6 0 -24.042065 -5.374879 10.098466 -5890 1554 4 0 -23.939428 -5.512490 9.105496 -5891 1554 4 0 -23.970753 -6.321333 10.460122 -5892 1555 6 0 -9.411597 6.559490 -16.669992 -5893 1555 4 0 -10.312323 6.551498 -16.403482 -5894 1555 4 0 -9.011995 5.640085 -16.634798 -5895 1556 6 0 9.530893 -11.884062 12.046782 -5896 1556 4 0 9.879650 -11.398694 11.280896 -5897 1556 4 0 9.261341 -11.231618 12.651989 -5898 1557 6 0 -1.911349 -16.933894 1.374617 -5899 1557 4 0 -2.219904 -17.739022 1.023023 -5900 1557 4 0 -1.747381 -16.334388 0.676612 -5901 1558 6 0 26.179381 -17.174136 0.502901 -5902 1558 4 0 25.703357 -17.150578 -0.364558 -5903 1558 4 0 25.879759 -16.529513 1.122222 -5904 1559 6 0 23.006008 2.418768 11.548952 -5905 1559 4 0 22.123244 2.196506 11.872833 -5906 1559 4 0 22.916266 2.423276 10.570078 -5907 1560 6 0 -25.061378 12.895337 -10.920642 -5908 1560 4 0 -24.236859 12.794849 -10.380539 -5909 1560 4 0 -24.844809 13.124176 -11.856801 -5910 1561 6 0 24.065450 16.186345 -1.562209 -5911 1561 4 0 23.818077 16.816733 -0.921419 -5912 1561 4 0 24.446065 16.798992 -2.179306 -5913 1562 6 0 21.877525 -11.997066 12.743827 -5914 1562 4 0 21.110101 -12.307846 12.276099 -5915 1562 4 0 21.795852 -11.028569 12.668947 -5916 1563 6 0 -9.770390 12.275988 6.625277 -5917 1563 4 0 -9.540551 11.529014 6.118639 -5918 1563 4 0 -9.063347 12.943993 6.639152 -5919 1564 6 0 7.590434 -16.518614 -3.885689 -5920 1564 4 0 8.245405 -16.780602 -4.602660 -5921 1564 4 0 8.060783 -16.730529 -3.006396 -5922 1565 6 0 -8.819809 7.819937 16.686859 -5923 1565 4 0 -8.459184 7.862962 15.781131 -5924 1565 4 0 -8.333215 7.208627 17.206742 -5925 1566 6 0 -0.018770 12.851916 7.726452 -5926 1566 4 0 -0.018534 13.815629 7.654360 -5927 1566 4 0 -0.678950 12.568762 8.379340 -5928 1567 6 0 26.935998 -2.260542 -4.734090 -5929 1567 4 0 27.692757 -2.309847 -5.350797 -5930 1567 4 0 27.186636 -2.518573 -3.802021 -5931 1568 6 0 27.034878 8.922183 -3.893061 -5932 1568 4 0 26.315953 9.520583 -3.776301 -5933 1568 4 0 27.485194 9.316156 -4.684455 -5934 1569 6 0 8.051349 7.651612 -11.998393 -5935 1569 4 0 8.628507 7.928025 -11.260450 -5936 1569 4 0 7.748144 8.473350 -12.355271 -5937 1570 6 0 -27.116258 -14.053521 12.105107 -5938 1570 4 0 -27.545532 -13.197780 12.384888 -5939 1570 4 0 -26.358772 -13.875946 11.579879 -5940 1571 6 0 23.554783 -11.406323 -3.754207 -5941 1571 4 0 24.096179 -11.152033 -2.997418 -5942 1571 4 0 23.941749 -11.074873 -4.532762 -5943 1572 6 0 -6.910654 -17.603975 17.334387 -5944 1572 4 0 -7.702761 -17.167889 17.745512 -5945 1572 4 0 -6.836320 -17.171292 16.454588 -5946 1573 6 0 -16.492037 5.302939 -1.579501 -5947 1573 4 0 -16.042514 4.646869 -2.112816 -5948 1573 4 0 -15.801804 6.017062 -1.587499 -5949 1574 6 0 -23.756350 3.926953 -8.179925 -5950 1574 4 0 -23.195167 4.286584 -8.893370 -5951 1574 4 0 -23.460247 3.034235 -7.983373 -5952 1575 6 0 -13.747357 8.818643 -3.799589 -5953 1575 4 0 -13.952688 8.414506 -2.934484 -5954 1575 4 0 -13.853214 9.757832 -3.600478 -5955 1576 6 0 -1.628128 -12.816264 -17.331527 -5956 1576 4 0 -2.433523 -13.356344 -17.119883 -5957 1576 4 0 -2.044696 -11.950129 -17.560931 -5958 1577 6 0 -0.085635 15.544048 -1.201911 -5959 1577 4 0 -0.000781 16.405004 -1.546695 -5960 1577 4 0 -0.971991 15.289121 -0.919162 -5961 1578 6 0 -8.590554 17.067218 -10.033341 -5962 1578 4 0 -8.478641 17.979748 -10.381694 -5963 1578 4 0 -9.177179 16.660222 -10.710438 -5964 1579 6 0 -18.092032 -16.862277 -18.860686 -5965 1579 4 0 -17.787112 -16.936281 -17.986509 -5966 1579 4 0 -18.687545 -17.567560 -19.061403 -5967 1580 6 0 11.369215 4.413430 15.924887 -5968 1580 4 0 11.372520 3.624729 15.359827 -5969 1580 4 0 11.705477 5.119414 15.321428 -5970 1581 6 0 12.784492 7.071253 19.464041 -5971 1581 4 0 12.860418 6.279814 18.965525 -5972 1581 4 0 12.277088 6.716268 20.219705 -5973 1582 6 0 12.068135 -8.262908 17.552171 -5974 1582 4 0 11.944483 -7.791072 18.350772 -5975 1582 4 0 12.525141 -9.091659 17.770424 -5976 1583 6 0 10.241854 4.742923 2.559332 -5977 1583 4 0 9.423895 4.504759 2.987600 -5978 1583 4 0 10.968724 4.120073 2.820528 -5979 1584 6 0 4.587851 -5.032891 12.160556 -5980 1584 4 0 4.431505 -4.242508 12.621627 -5981 1584 4 0 5.402359 -4.988575 11.647199 -5982 1585 6 0 -24.230874 -6.577818 -16.070853 -5983 1585 4 0 -23.682020 -6.608606 -15.296098 -5984 1585 4 0 -25.097764 -7.040376 -15.909446 -5985 1586 6 0 20.182613 7.158966 1.874949 -5986 1586 4 0 20.915498 6.541606 2.146531 -5987 1586 4 0 20.710894 7.927513 1.477203 -5988 1587 6 0 21.755390 6.896132 -12.917138 -5989 1587 4 0 22.076449 7.236600 -12.089303 -5990 1587 4 0 22.525120 6.527089 -13.344666 -5991 1588 6 0 6.877822 -4.771079 6.941634 -5992 1588 4 0 7.368474 -3.917167 6.794895 -5993 1588 4 0 6.561555 -4.815923 7.876455 -5994 1589 6 0 -17.794941 18.359853 16.305117 -5995 1589 4 0 -18.421394 18.650198 16.927781 -5996 1589 4 0 -17.650629 19.254815 15.811542 -5997 1590 6 0 -2.602624 -16.412046 -10.596632 -5998 1590 4 0 -2.730413 -15.479270 -10.244360 -5999 1590 4 0 -1.636947 -16.665956 -10.610129 -6000 1591 6 0 3.935143 -2.077202 16.379950 -6001 1591 4 0 3.116180 -2.074570 16.871393 -6002 1591 4 0 4.258130 -3.011541 16.214763 -6003 1592 6 0 26.054987 14.635245 18.309718 -6004 1592 4 0 27.012144 14.531484 18.422001 -6005 1592 4 0 25.883129 15.612156 18.232382 -6006 1593 6 0 22.186055 -2.285036 -18.276384 -6007 1593 4 0 22.575561 -1.490206 -18.592190 -6008 1593 4 0 21.774977 -1.952262 -17.452519 -6009 1594 6 0 5.982701 12.874655 -19.536076 -6010 1594 4 0 6.160786 13.198075 -20.428652 -6011 1594 4 0 6.854019 12.668623 -19.180374 -6012 1595 6 0 -6.054158 -13.744402 -7.200732 -6013 1595 4 0 -6.689102 -14.438760 -7.467162 -6014 1595 4 0 -5.241683 -14.218938 -7.253580 -6015 1596 6 0 7.766648 -19.472206 -8.674412 -6016 1596 4 0 7.994143 -19.850740 -7.811770 -6017 1596 4 0 7.159819 -20.051349 -9.144842 -6018 1597 6 0 -13.899693 -2.310609 11.719170 -6019 1597 4 0 -14.293895 -1.540339 11.338780 -6020 1597 4 0 -13.136046 -1.840341 12.108102 -6021 1598 6 0 26.880118 -3.988040 -2.564260 -6022 1598 4 0 27.141785 -3.912376 -1.619664 -6023 1598 4 0 25.991507 -4.403119 -2.509330 -6024 1599 6 0 16.831698 -0.370079 16.786168 -6025 1599 4 0 17.550555 0.178386 16.456695 -6026 1599 4 0 17.096485 -0.465948 17.715552 -6027 1600 6 0 19.019953 8.994801 17.672825 -6028 1600 4 0 18.825567 9.927341 17.839722 -6029 1600 4 0 19.072225 8.455310 18.528449 -6030 1601 6 0 -23.890734 -17.531047 20.103131 -6031 1601 4 0 -24.410048 -17.249588 20.880036 -6032 1601 4 0 -23.243461 -16.838233 19.952601 -6033 1602 6 0 24.612082 6.311703 -14.314049 -6034 1602 4 0 24.685511 6.721117 -15.194578 -6035 1602 4 0 24.456182 5.357259 -14.330432 -6036 1603 6 0 11.630912 5.335794 8.212450 -6037 1603 4 0 10.744689 5.096999 8.355771 -6038 1603 4 0 11.632399 6.142908 7.660144 -6039 1604 6 0 16.482829 -7.676138 17.246704 -6040 1604 4 0 15.832973 -7.172968 16.764273 -6041 1604 4 0 17.323015 -7.087522 17.068424 -6042 1605 6 0 -14.246850 -1.445493 8.521283 -6043 1605 4 0 -14.965431 -1.234868 9.098827 -6044 1605 4 0 -14.565647 -2.243574 8.052945 -6045 1606 6 0 -12.243735 5.878745 14.287709 -6046 1606 4 0 -12.931194 5.878071 14.927194 -6047 1606 4 0 -12.476832 5.118118 13.758795 -6048 1607 6 0 14.365931 -20.845025 6.067181 -6049 1607 4 0 14.538057 -20.237448 6.808442 -6050 1607 4 0 15.204917 -21.078698 5.761047 -6051 1608 6 0 16.298718 -4.138023 18.121710 -6052 1608 4 0 15.424215 -3.680129 18.372722 -6053 1608 4 0 16.684549 -4.205202 19.001012 -6054 1609 6 0 -14.198508 -14.194772 -14.794207 -6055 1609 4 0 -13.444357 -14.590983 -14.343955 -6056 1609 4 0 -13.774495 -13.612371 -15.434882 -6057 1610 6 0 -10.030484 -15.925396 14.049869 -6058 1610 4 0 -9.661016 -16.753356 13.643301 -6059 1610 4 0 -9.506338 -15.169357 13.752939 -6060 1611 6 0 2.620657 -7.959507 -20.667278 -6061 1611 4 0 2.062110 -7.160386 -20.605865 -6062 1611 4 0 2.138798 -8.553220 -21.271787 -6063 1612 6 0 5.778060 4.436909 12.837835 -6064 1612 4 0 5.362329 3.721975 13.322111 -6065 1612 4 0 5.808629 5.246373 13.380366 -6066 1613 6 0 16.866472 5.920215 7.405820 -6067 1613 4 0 16.435352 5.086965 7.209575 -6068 1613 4 0 16.163833 6.543037 7.470100 -6069 1614 6 0 17.825944 -3.501642 -5.065436 -6070 1614 4 0 17.700510 -2.538825 -4.863235 -6071 1614 4 0 18.532466 -3.602326 -5.702852 -6072 1615 6 0 -11.681593 20.597292 5.432499 -6073 1615 4 0 -11.969564 21.510542 5.152859 -6074 1615 4 0 -12.562576 20.147115 5.430236 -6075 1616 6 0 21.531845 -18.609965 -11.465553 -6076 1616 4 0 21.036885 -18.970566 -10.752405 -6077 1616 4 0 20.911041 -18.252243 -12.167168 -6078 1617 6 0 0.249866 -13.875504 -5.737561 -6079 1617 4 0 1.053242 -14.152812 -5.334020 -6080 1617 4 0 0.540234 -13.078009 -6.238789 -6081 1618 6 0 3.047539 17.051565 11.568254 -6082 1618 4 0 3.164343 17.306128 12.474589 -6083 1618 4 0 2.524042 17.779795 11.213697 -6084 1619 6 0 24.178795 -4.873391 -17.954897 -6085 1619 4 0 23.609912 -4.083965 -18.078992 -6086 1619 4 0 24.401168 -4.923489 -16.992528 -6087 1620 6 0 3.954939 20.513379 -14.418517 -6088 1620 4 0 3.581046 20.093104 -15.154897 -6089 1620 4 0 3.811800 21.468596 -14.662255 -6090 1621 6 0 -0.149556 2.777227 -12.291758 -6091 1621 4 0 -0.121223 2.435369 -11.351012 -6092 1621 4 0 0.596183 3.441893 -12.318897 -6093 1622 6 0 27.193112 8.418341 -10.172198 -6094 1622 4 0 26.787164 8.259494 -11.042944 -6095 1622 4 0 27.410726 9.433106 -10.260356 -6096 1623 6 0 -24.022975 1.655208 -11.524687 -6097 1623 4 0 -24.291048 0.824835 -11.888466 -6098 1623 4 0 -24.881489 1.940641 -11.171341 -6099 1624 6 0 26.405280 -5.462847 -5.065504 -6100 1624 4 0 26.209462 -6.029181 -5.803215 -6101 1624 4 0 27.373218 -5.317034 -5.077630 -6102 1625 6 0 -3.690721 10.045789 -20.208648 -6103 1625 4 0 -4.248266 9.317998 -19.851069 -6104 1625 4 0 -2.834866 9.590938 -20.465215 -6105 1626 6 0 -2.559171 12.379195 -18.651596 -6106 1626 4 0 -3.295406 13.039384 -18.601178 -6107 1626 4 0 -2.957289 11.575659 -18.948915 -6108 1627 6 0 9.997514 -3.540058 20.611729 -6109 1627 4 0 9.428623 -3.673422 21.365363 -6110 1627 4 0 10.919581 -3.718379 20.892643 -6111 1628 6 0 22.711145 -8.644902 0.632604 -6112 1628 4 0 23.670226 -8.511619 0.628432 -6113 1628 4 0 22.493868 -9.498519 0.275412 -6114 1629 6 0 14.085903 -1.038370 -16.414394 -6115 1629 4 0 14.059869 -1.196217 -15.467296 -6116 1629 4 0 13.262318 -1.459953 -16.715075 -6117 1630 6 0 -12.216643 15.094727 14.953780 -6118 1630 4 0 -11.931679 15.769402 14.281719 -6119 1630 4 0 -13.149517 15.224147 15.123844 -6120 1631 6 0 -24.757277 7.231003 8.542276 -6121 1631 4 0 -24.784189 8.210199 8.450823 -6122 1631 4 0 -24.549551 6.922193 9.397707 -6123 1632 6 0 3.372929 19.847026 -0.606151 -6124 1632 4 0 3.191569 19.283633 -1.369340 -6125 1632 4 0 4.347642 20.010416 -0.683022 -6126 1633 6 0 8.872330 -16.761760 17.202410 -6127 1633 4 0 8.996558 -17.151460 16.293393 -6128 1633 4 0 9.700285 -17.024144 17.621618 -6129 1634 6 0 9.343569 14.953908 -19.877613 -6130 1634 4 0 9.005091 14.803515 -18.977870 -6131 1634 4 0 10.168474 14.477496 -19.931351 -6132 1635 6 0 2.034725 4.776928 20.854933 -6133 1635 4 0 2.700859 5.449702 20.919206 -6134 1635 4 0 1.289075 5.153942 21.314556 -6135 1636 6 0 18.285982 7.046313 3.854888 -6136 1636 4 0 18.754091 7.109170 3.047358 -6137 1636 4 0 18.852898 6.489134 4.447893 -6138 1637 6 0 17.000427 19.166068 19.844454 -6139 1637 4 0 17.780774 18.891038 19.347291 -6140 1637 4 0 16.338665 18.528198 19.533743 -6141 1638 6 0 4.309924 6.553220 -20.552969 -6142 1638 4 0 4.375422 6.917713 -21.455723 -6143 1638 4 0 5.249758 6.290930 -20.364274 -6144 1639 6 0 20.777753 -4.985339 -6.248152 -6145 1639 4 0 20.286399 -4.821264 -7.053768 -6146 1639 4 0 20.234568 -5.537952 -5.671124 -6147 1640 6 0 4.730675 15.020276 -10.674086 -6148 1640 4 0 4.376943 14.834207 -9.767214 -6149 1640 4 0 4.726770 15.973286 -10.733237 -6150 1641 6 0 2.355355 1.234033 17.572616 -6151 1641 4 0 3.034023 1.365267 16.849468 -6152 1641 4 0 1.929729 2.103871 17.645246 -6153 1642 6 0 -20.364763 -10.341423 19.798444 -6154 1642 4 0 -20.097141 -9.967826 18.943902 -6155 1642 4 0 -20.518570 -9.582890 20.375779 -6156 1643 6 0 24.191317 -20.301143 13.503559 -6157 1643 4 0 25.075667 -20.080336 13.914227 -6158 1643 4 0 23.551864 -19.853712 14.034970 -6159 1644 6 0 -17.771965 -0.812840 5.691659 -6160 1644 4 0 -17.110001 -0.172585 5.922995 -6161 1644 4 0 -18.609271 -0.533119 5.998788 -6162 1645 6 0 8.428411 7.992467 20.234546 -6163 1645 4 0 9.349683 8.062329 20.534745 -6164 1645 4 0 7.930578 8.665863 20.632958 -6165 1646 6 0 14.933965 18.875827 -5.159997 -6166 1646 4 0 14.094884 19.194527 -5.500018 -6167 1646 4 0 15.603425 19.608364 -5.196749 -6168 1647 6 0 -11.010909 -1.265131 18.652423 -6169 1647 4 0 -11.027649 -1.155636 17.705218 -6170 1647 4 0 -10.091875 -1.091225 18.938417 -6171 1648 6 0 -21.191413 -9.651017 -4.562795 -6172 1648 4 0 -20.962638 -9.680538 -5.508642 -6173 1648 4 0 -20.795476 -10.416878 -4.182448 -6174 1649 6 0 5.099725 -12.626597 -17.884817 -6175 1649 4 0 5.666927 -12.400935 -17.105607 -6176 1649 4 0 4.764175 -11.785457 -18.184293 -6177 1650 6 0 -21.388510 -5.492100 10.971049 -6178 1650 4 0 -22.216480 -5.626371 10.534286 -6179 1650 4 0 -21.551676 -5.367629 11.909886 -6180 1651 6 0 -26.689928 -8.293398 13.111418 -6181 1651 4 0 -27.003954 -8.182450 12.219010 -6182 1651 4 0 -26.900928 -9.235390 13.263182 -6183 1652 6 0 6.162303 19.062401 -17.622686 -6184 1652 4 0 5.955026 19.807434 -17.095725 -6185 1652 4 0 6.287880 18.311383 -17.062421 -6186 1653 6 0 -26.568944 19.936247 1.863051 -6187 1653 4 0 -26.429552 19.451776 1.050937 -6188 1653 4 0 -25.730651 20.069282 2.308590 -6189 1654 6 0 -12.939452 -17.938569 9.558916 -6190 1654 4 0 -12.598970 -18.093496 10.439491 -6191 1654 4 0 -13.201371 -18.755858 9.152488 -6192 1655 6 0 -11.464685 7.314998 -14.468616 -6193 1655 4 0 -12.254067 7.075040 -13.971198 -6194 1655 4 0 -11.784844 7.883355 -15.166065 -6195 1656 6 0 20.495565 -8.915532 9.256247 -6196 1656 4 0 19.761356 -9.177749 9.963841 -6197 1656 4 0 20.333767 -7.961456 9.244216 -6198 1657 6 0 -16.958223 -6.637117 15.942724 -6199 1657 4 0 -17.590511 -6.925764 15.256778 -6200 1657 4 0 -17.006530 -7.309307 16.639627 -6201 1658 6 0 -7.465242 20.880802 3.955458 -6202 1658 4 0 -6.906639 21.395406 3.368693 -6203 1658 4 0 -7.384772 21.435308 4.777200 -6204 1659 6 0 10.987484 -10.220761 -0.486092 -6205 1659 4 0 11.657995 -10.039232 -1.157052 -6206 1659 4 0 10.134305 -10.217278 -0.922065 -6207 1660 6 0 -11.745045 12.656305 2.561380 -6208 1660 4 0 -12.067404 12.975187 3.387647 -6209 1660 4 0 -11.009457 12.085090 2.865904 -6210 1661 6 0 -5.579572 -16.497607 -20.750701 -6211 1661 4 0 -4.847773 -16.621590 -21.371280 -6212 1661 4 0 -6.034567 -17.358476 -20.680344 -6213 1662 6 0 1.964841 -7.772342 -15.446535 -6214 1662 4 0 2.789953 -8.261174 -15.222416 -6215 1662 4 0 1.224980 -8.401255 -15.497885 -6216 1663 6 0 17.133687 20.836195 -5.235713 -6217 1663 4 0 16.963395 21.728366 -4.832203 -6218 1663 4 0 18.061664 20.710791 -5.306008 -6219 1664 6 0 -18.390780 10.973515 3.704388 -6220 1664 4 0 -19.253132 11.409402 3.769882 -6221 1664 4 0 -18.035350 10.771168 4.577357 -6222 1665 6 0 14.221292 20.673222 -19.936970 -6223 1665 4 0 13.920637 20.243897 -20.741067 -6224 1665 4 0 14.685112 21.462779 -20.332088 -6225 1666 6 0 -21.084831 12.253935 9.565359 -6226 1666 4 0 -20.600168 11.482007 9.886149 -6227 1666 4 0 -21.728096 12.542158 10.140605 -6228 1667 6 0 21.807475 -0.416214 2.152466 -6229 1667 4 0 22.039987 -0.306167 1.206900 -6230 1667 4 0 22.400722 -1.068057 2.516791 -6231 1668 6 0 20.924050 10.441338 14.208356 -6232 1668 4 0 21.615541 10.869208 14.797933 -6233 1668 4 0 20.771960 9.540413 14.573568 -6234 1669 6 0 6.259921 4.454937 -17.265429 -6235 1669 4 0 6.706330 4.203652 -18.064753 -6236 1669 4 0 5.711163 3.710753 -17.001578 -6237 1670 6 0 -4.214022 14.596706 -18.431597 -6238 1670 4 0 -3.688756 15.025866 -17.718188 -6239 1670 4 0 -5.088033 14.473133 -18.084790 -6240 1671 6 0 -2.199419 13.906578 9.672426 -6241 1671 4 0 -2.129396 13.038932 9.992785 -6242 1671 4 0 -3.120153 14.058476 9.477073 -6243 1672 6 0 9.044748 2.046702 -11.991573 -6244 1672 4 0 9.465655 2.820071 -11.709794 -6245 1672 4 0 8.080161 2.265383 -12.092250 -6246 1673 6 0 7.143894 -11.920235 -15.669336 -6247 1673 4 0 6.531119 -11.505986 -15.060545 -6248 1673 4 0 7.414267 -12.765754 -15.195832 -6249 1674 6 0 -5.826228 -0.168688 14.337506 -6250 1674 4 0 -5.465882 -0.527232 13.513436 -6251 1674 4 0 -5.608854 0.802946 14.323569 -6252 1675 6 0 5.648885 3.826675 19.190577 -6253 1675 4 0 5.186784 3.361795 19.925791 -6254 1675 4 0 5.056212 3.823989 18.450900 -6255 1676 6 0 9.326815 -6.082614 -17.012500 -6256 1676 4 0 10.201835 -6.094812 -17.433769 -6257 1676 4 0 9.461714 -5.493002 -16.251384 -6258 1677 6 0 -1.961522 -12.154184 11.549933 -6259 1677 4 0 -1.624684 -11.469274 10.968619 -6260 1677 4 0 -2.192863 -11.701664 12.378278 -6261 1678 6 0 22.610380 9.966271 5.674665 -6262 1678 4 0 23.383558 10.326639 6.158091 -6263 1678 4 0 22.639822 10.376867 4.833334 -6264 1679 6 0 -15.460748 19.613439 2.679694 -6265 1679 4 0 -16.411896 19.506793 2.586178 -6266 1679 4 0 -14.953260 19.393944 1.878689 -6267 1680 6 0 -9.915773 -6.329847 7.803991 -6268 1680 4 0 -9.882720 -5.651785 8.461110 -6269 1680 4 0 -10.460430 -6.991760 8.214687 -6270 1681 6 0 -25.207118 14.245870 9.965310 -6271 1681 4 0 -24.983683 14.155643 9.024696 -6272 1681 4 0 -26.142233 13.940881 10.004034 -6273 1682 6 0 -25.736790 -11.761067 -20.022820 -6274 1682 4 0 -25.863929 -11.074881 -20.678750 -6275 1682 4 0 -24.932339 -12.237137 -20.159436 -6276 1683 6 0 11.102836 18.814945 6.564463 -6277 1683 4 0 11.289797 19.730591 6.307298 -6278 1683 4 0 11.992226 18.441595 6.571960 -6279 1684 6 0 13.403000 -2.765436 13.474813 -6280 1684 4 0 13.769730 -2.059344 13.993878 -6281 1684 4 0 12.629241 -3.051764 13.938568 -6282 1685 6 0 -4.846771 12.989332 0.138872 -6283 1685 4 0 -5.140341 12.692091 -0.669471 -6284 1685 4 0 -4.237694 12.323085 0.503203 -6285 1686 6 0 -7.158804 -10.565376 -14.125410 -6286 1686 4 0 -7.106658 -9.969989 -13.387772 -6287 1686 4 0 -8.014522 -10.262139 -14.505555 -6288 1687 6 0 -27.281285 1.637807 7.500082 -6289 1687 4 0 -28.034365 1.595491 8.055974 -6290 1687 4 0 -27.473389 0.963037 6.821339 -6291 1688 6 0 -0.097834 20.799965 16.033059 -6292 1688 4 0 -0.061833 20.955427 16.971561 -6293 1688 4 0 0.211633 19.849506 15.947964 -6294 1689 6 0 -17.560941 -8.904350 -7.470152 -6295 1689 4 0 -17.692194 -9.827361 -7.296744 -6296 1689 4 0 -18.413628 -8.634527 -7.892701 -6297 1690 6 0 19.510410 -2.135779 6.750602 -6298 1690 4 0 19.129310 -2.691827 6.012246 -6299 1690 4 0 19.916248 -2.816246 7.354253 -6300 1691 6 0 -22.550074 2.726993 8.069055 -6301 1691 4 0 -22.055287 3.149406 8.816420 -6302 1691 4 0 -23.436863 2.498421 8.376578 -6303 1692 6 0 12.975725 16.091516 4.066177 -6304 1692 4 0 12.574447 15.652668 4.834328 -6305 1692 4 0 13.351330 15.347325 3.556206 -6306 1693 6 0 4.646769 -11.986650 5.429828 -6307 1693 4 0 4.999571 -11.714192 4.521067 -6308 1693 4 0 3.860805 -12.541717 5.180051 -6309 1694 6 0 -25.235875 -9.797804 -17.843826 -6310 1694 4 0 -24.333006 -9.678887 -17.478651 -6311 1694 4 0 -25.154219 -10.357082 -18.609102 -6312 1695 6 0 11.868872 -11.212949 -8.438903 -6313 1695 4 0 11.896093 -12.062241 -7.862109 -6314 1695 4 0 12.728803 -11.139741 -8.855401 -6315 1696 6 0 17.367617 -1.497743 -14.604934 -6316 1696 4 0 17.309530 -0.538237 -14.454327 -6317 1696 4 0 16.651273 -1.922704 -14.219436 -6318 1697 6 0 8.667339 4.899012 8.930629 -6319 1697 4 0 8.353473 5.408040 8.182722 -6320 1697 4 0 8.163336 5.229248 9.676915 -6321 1698 6 0 -15.429574 17.683315 9.572006 -6322 1698 4 0 -15.724205 17.604776 10.464011 -6323 1698 4 0 -15.265015 16.716829 9.310192 -6324 1699 6 0 -23.494483 -11.734522 -13.358407 -6325 1699 4 0 -22.637486 -11.515244 -13.732205 -6326 1699 4 0 -23.249990 -12.537148 -12.866248 -6327 1700 6 0 -2.321548 19.267216 -1.843679 -6328 1700 4 0 -1.979401 18.732155 -2.589027 -6329 1700 4 0 -1.922284 20.138548 -2.014462 -6330 1701 6 0 3.241639 7.816664 9.859978 -6331 1701 4 0 3.830186 8.534324 10.230363 -6332 1701 4 0 3.848530 7.292787 9.307399 -6333 1702 6 0 23.128975 -6.691964 -6.315464 -6334 1702 4 0 23.778438 -6.570891 -6.974137 -6335 1702 4 0 22.501465 -5.970161 -6.490266 -6336 1703 6 0 19.510034 14.065263 20.822119 -6337 1703 4 0 19.858660 14.498532 21.601080 -6338 1703 4 0 18.527411 14.085196 20.963708 -6339 1704 6 0 23.620502 15.862352 -17.889270 -6340 1704 4 0 23.702347 16.808368 -17.871251 -6341 1704 4 0 24.460420 15.474942 -18.227702 -6342 1705 6 0 0.280487 -11.413982 6.100970 -6343 1705 4 0 -0.020983 -11.734838 5.286550 -6344 1705 4 0 -0.533188 -11.093828 6.515383 -6345 1706 6 0 4.888182 13.212978 -12.788937 -6346 1706 4 0 4.811212 13.849406 -12.115682 -6347 1706 4 0 5.658749 13.451904 -13.292659 -6348 1707 6 0 -0.778683 -14.633842 19.192088 -6349 1707 4 0 0.068746 -14.541913 19.608269 -6350 1707 4 0 -0.746217 -14.102331 18.428497 -6351 1708 6 0 13.914707 -6.162346 9.195387 -6352 1708 4 0 13.649776 -6.881207 8.533412 -6353 1708 4 0 13.921705 -5.396594 8.630327 -6354 1709 6 0 5.918950 -10.003796 18.819888 -6355 1709 4 0 5.593681 -9.082358 18.773797 -6356 1709 4 0 6.335696 -10.082856 17.966116 -6357 1710 6 0 5.800793 -13.047074 9.485819 -6358 1710 4 0 5.149198 -12.578404 10.015587 -6359 1710 4 0 5.268076 -13.674415 8.965513 -6360 1711 6 0 -14.871416 6.062880 9.725201 -6361 1711 4 0 -14.929573 6.618371 8.917863 -6362 1711 4 0 -14.144906 5.419527 9.466087 -6363 1712 6 0 20.324875 13.466462 -0.499122 -6364 1712 4 0 21.247971 13.704707 -0.183814 -6365 1712 4 0 20.407782 13.624960 -1.484430 -6366 1713 6 0 14.435517 -20.166926 -14.557910 -6367 1713 4 0 15.392894 -20.186163 -14.367445 -6368 1713 4 0 14.408577 -20.346774 -15.497151 -6369 1714 6 0 -16.234833 1.803853 -11.857132 -6370 1714 4 0 -16.542525 1.963315 -10.988159 -6371 1714 4 0 -16.125965 2.663685 -12.253266 -6372 1715 6 0 5.603802 10.853652 14.181232 -6373 1715 4 0 4.967001 11.570744 14.103506 -6374 1715 4 0 5.112428 10.099067 14.600012 -6375 1716 6 0 -9.571538 -5.196535 -13.987191 -6376 1716 4 0 -8.921300 -5.201306 -13.287766 -6377 1716 4 0 -9.272779 -4.631556 -14.762861 -6378 1717 6 0 -0.910109 -6.872259 20.397408 -6379 1717 4 0 -1.142400 -7.798393 20.536047 -6380 1717 4 0 -1.036778 -6.702293 19.444051 -6381 1718 6 0 -12.922858 14.220990 -13.435094 -6382 1718 4 0 -13.045814 13.904342 -12.512925 -6383 1718 4 0 -11.991363 14.443415 -13.600018 -6384 1719 6 0 -20.145038 7.688023 -15.204652 -6385 1719 4 0 -19.285409 7.391425 -14.875634 -6386 1719 4 0 -20.496640 7.059764 -15.839841 -6387 1720 6 0 -5.329489 -11.195881 -18.058590 -6388 1720 4 0 -4.529646 -10.716556 -18.053482 -6389 1720 4 0 -5.175370 -11.944129 -17.502821 -6390 1721 6 0 -4.095176 7.801479 14.167088 -6391 1721 4 0 -4.165281 6.967753 13.710500 -6392 1721 4 0 -4.424466 8.518942 13.657209 -6393 1722 6 0 4.268934 -2.427400 -14.058821 -6394 1722 4 0 3.658313 -1.685938 -14.058738 -6395 1722 4 0 4.003282 -2.951965 -14.808726 -6396 1723 6 0 8.751768 -9.075907 8.222826 -6397 1723 4 0 8.238298 -9.781595 7.726938 -6398 1723 4 0 8.832788 -8.372787 7.566934 -6399 1724 6 0 -2.030633 -16.421805 9.382972 -6400 1724 4 0 -3.001825 -16.480774 9.651189 -6401 1724 4 0 -1.831960 -15.434055 9.498271 -6402 1725 6 0 -25.423917 -5.184358 19.460275 -6403 1725 4 0 -25.411355 -4.513854 18.790648 -6404 1725 4 0 -24.533549 -5.279059 19.872583 -6405 1726 6 0 -2.666399 -5.808727 -16.793146 -6406 1726 4 0 -2.024398 -6.172832 -16.200012 -6407 1726 4 0 -3.330516 -5.483909 -16.238573 -6408 1727 6 0 21.181989 15.710253 -10.722839 -6409 1727 4 0 20.653330 16.200547 -11.388544 -6410 1727 4 0 20.518018 15.224350 -10.216895 -6411 1728 6 0 10.656923 -19.476259 -2.456922 -6412 1728 4 0 10.832717 -19.488093 -3.445481 -6413 1728 4 0 10.250558 -20.351142 -2.291869 -6414 1729 6 0 25.111320 11.672906 -19.193595 -6415 1729 4 0 25.138171 11.478665 -18.282125 -6416 1729 4 0 24.182357 11.511761 -19.351363 -6417 1730 6 0 -23.200367 10.470264 2.902172 -6418 1730 4 0 -22.375402 10.749923 3.283481 -6419 1730 4 0 -23.150590 10.446395 1.924180 -6420 1731 6 0 -2.505105 -5.473938 -19.743686 -6421 1731 4 0 -1.843966 -5.849443 -20.362634 -6422 1731 4 0 -2.920619 -6.270770 -19.289080 -6423 1732 6 0 -8.780745 -1.877077 -14.922296 -6424 1732 4 0 -8.514938 -2.635843 -15.397360 -6425 1732 4 0 -9.085199 -1.200825 -15.532893 -6426 1733 6 0 24.088505 -5.188189 -2.808937 -6427 1733 4 0 23.599921 -6.002172 -2.943267 -6428 1733 4 0 23.455922 -4.686553 -2.320873 -6429 1734 6 0 22.351359 7.425470 -10.093129 -6430 1734 4 0 22.221254 8.332765 -9.845260 -6431 1734 4 0 21.646534 6.920728 -9.570168 -6432 1735 6 0 14.350169 18.359669 4.097284 -6433 1735 4 0 14.109937 17.421914 3.931070 -6434 1735 4 0 14.072554 18.536427 5.036536 -6435 1736 6 0 27.317468 -3.450042 0.124188 -6436 1736 4 0 26.939527 -2.629423 0.463932 -6437 1736 4 0 28.260772 -3.496973 0.454380 -6438 1737 6 0 18.669483 0.162292 12.223874 -6439 1737 4 0 17.730334 0.262878 12.571330 -6440 1737 4 0 18.943346 -0.589794 12.749858 -6441 1738 6 0 -5.566955 -16.930775 -16.571789 -6442 1738 4 0 -6.441648 -17.209772 -16.309110 -6443 1738 4 0 -5.639154 -16.106816 -17.074766 -6444 1739 6 0 -2.921475 20.285760 15.744633 -6445 1739 4 0 -2.016920 20.514916 15.782961 -6446 1739 4 0 -3.245126 20.259651 16.667577 -6447 1740 6 0 -5.332369 15.647169 -3.415792 -6448 1740 4 0 -5.780073 16.016536 -4.186943 -6449 1740 4 0 -5.479798 16.195769 -2.646722 -6450 1741 6 0 15.921074 -18.186514 13.419302 -6451 1741 4 0 16.506049 -18.207521 14.214727 -6452 1741 4 0 15.521744 -17.337545 13.281325 -6453 1742 6 0 14.356618 -12.746498 14.307435 -6454 1742 4 0 14.126271 -12.290732 13.456316 -6455 1742 4 0 14.125424 -12.072615 14.973510 -6456 1743 6 0 -24.563586 19.861169 16.888289 -6457 1743 4 0 -24.271423 19.518156 17.745286 -6458 1743 4 0 -25.132062 20.568890 17.055680 -6459 1744 6 0 21.313706 -20.874831 -18.789259 -6460 1744 4 0 22.217533 -20.760960 -18.415032 -6461 1744 4 0 20.727813 -20.829114 -18.018243 -6462 1745 6 0 -22.635680 0.425745 -16.655779 -6463 1745 4 0 -22.761860 0.339162 -17.612196 -6464 1745 4 0 -23.459506 0.792307 -16.373813 -6465 1746 6 0 26.144043 -9.495490 -14.387597 -6466 1746 4 0 25.579221 -8.746398 -14.601070 -6467 1746 4 0 25.873666 -10.165392 -15.002042 -6468 1747 6 0 -23.297595 -18.906211 -0.461159 -6469 1747 4 0 -22.408325 -19.188074 -0.167323 -6470 1747 4 0 -23.911286 -19.189688 0.234806 -6471 1748 6 0 -0.622548 17.838288 10.712907 -6472 1748 4 0 -1.439971 18.247686 10.442799 -6473 1748 4 0 -0.378140 17.187351 10.096413 -6474 1749 6 0 15.411072 -13.353252 8.623995 -6475 1749 4 0 14.707363 -12.901715 8.076042 -6476 1749 4 0 15.905287 -13.988830 8.076423 -6477 1750 6 0 21.923001 -19.583331 -14.240322 -6478 1750 4 0 22.075731 -18.649005 -14.150919 -6479 1750 4 0 22.015325 -19.897017 -13.337089 -6480 1751 6 0 2.935997 17.036657 8.133011 -6481 1751 4 0 3.807044 17.141662 7.698882 -6482 1751 4 0 2.908723 17.824640 8.654298 -6483 1752 6 0 -27.412013 18.278336 3.981062 -6484 1752 4 0 -28.006219 18.986550 3.874615 -6485 1752 4 0 -26.604657 18.625220 3.564949 -6486 1753 6 0 24.767119 -17.376689 8.467100 -6487 1753 4 0 25.034677 -18.274073 8.247745 -6488 1753 4 0 24.572504 -17.372764 9.407309 -6489 1754 6 0 -13.003243 -11.441578 13.780080 -6490 1754 4 0 -12.042782 -11.458495 13.652747 -6491 1754 4 0 -13.148063 -12.394708 13.704955 -6492 1755 6 0 15.688282 -7.232516 -0.339939 -6493 1755 4 0 16.449877 -6.627843 -0.361901 -6494 1755 4 0 14.991365 -6.661690 -0.041038 -6495 1756 6 0 11.147257 19.763552 -1.319428 -6496 1756 4 0 12.091516 19.826512 -1.542128 -6497 1756 4 0 10.791166 18.908813 -1.667004 -6498 1757 6 0 -7.494481 -7.378915 14.293630 -6499 1757 4 0 -8.055772 -6.598314 14.231678 -6500 1757 4 0 -7.492239 -7.996336 13.497808 -6501 1758 6 0 12.398150 -14.923360 -13.423871 -6502 1758 4 0 13.226011 -15.063936 -12.905542 -6503 1758 4 0 12.384263 -15.811229 -13.930308 -6504 1759 6 0 -27.354781 16.207013 -2.080282 -6505 1759 4 0 -27.773374 15.417476 -1.753252 -6506 1759 4 0 -26.769089 15.853853 -2.726016 -6507 1760 6 0 -21.588756 -10.691290 -14.634202 -6508 1760 4 0 -20.864974 -10.142417 -14.313329 -6509 1760 4 0 -22.092217 -10.206931 -15.343402 -6510 1761 6 0 -15.891662 -2.331448 -9.986612 -6511 1761 4 0 -16.165526 -2.271915 -10.920230 -6512 1761 4 0 -16.438270 -1.699757 -9.489314 -6513 1762 6 0 22.887456 16.566156 19.955577 -6514 1762 4 0 23.271415 15.746747 20.347130 -6515 1762 4 0 22.072508 16.181382 19.562781 -6516 1763 6 0 23.972546 -20.036642 10.589623 -6517 1763 4 0 22.980691 -20.033626 10.504814 -6518 1763 4 0 24.188289 -20.743981 11.184377 -6519 1764 6 0 -14.810897 -16.471565 2.793852 -6520 1764 4 0 -14.868506 -16.959673 3.603780 -6521 1764 4 0 -15.147942 -15.567810 2.891865 -6522 1765 6 0 15.022183 19.763656 9.414504 -6523 1765 4 0 14.727721 20.725814 9.294400 -6524 1765 4 0 14.198126 19.316744 9.803487 -6525 1766 6 0 7.167340 -17.033861 0.122492 -6526 1766 4 0 7.922624 -17.174527 -0.428152 -6527 1766 4 0 7.373246 -16.583291 0.937782 -6528 1767 6 0 -11.594968 10.896089 -10.580500 -6529 1767 4 0 -11.121081 11.033261 -11.432170 -6530 1767 4 0 -10.865005 11.002637 -9.903313 -6531 1768 6 0 13.844708 19.069913 -14.047834 -6532 1768 4 0 12.983337 18.716343 -13.811534 -6533 1768 4 0 13.787413 20.053839 -14.066463 -6534 1769 6 0 3.487281 19.589235 9.612730 -6535 1769 4 0 2.698355 20.090461 9.969632 -6536 1769 4 0 4.250101 19.910242 10.053781 -6537 1770 6 0 -3.973097 19.421213 7.719503 -6538 1770 4 0 -4.241991 20.257528 7.213642 -6539 1770 4 0 -3.132076 19.220373 7.212628 -6540 1771 6 0 -12.775076 2.609100 10.411237 -6541 1771 4 0 -11.827718 2.459042 10.644395 -6542 1771 4 0 -12.804655 2.331119 9.464699 -6543 1772 6 0 -24.197168 6.439006 -6.711367 -6544 1772 4 0 -25.160507 6.393035 -6.538446 -6545 1772 4 0 -23.942233 5.506445 -6.828627 -6546 1773 6 0 -2.117774 -4.949968 18.594717 -6547 1773 4 0 -2.924336 -5.465197 18.506055 -6548 1773 4 0 -2.296534 -4.057750 18.222583 -6549 1774 6 0 -10.788206 6.295992 1.048829 -6550 1774 4 0 -10.485607 7.066710 1.589289 -6551 1774 4 0 -10.038032 6.105261 0.487985 -6552 1775 6 0 -12.857377 -3.305264 -10.725085 -6553 1775 4 0 -13.206640 -2.923560 -11.499351 -6554 1775 4 0 -13.499606 -3.077602 -10.047332 -6555 1776 6 0 -11.268130 12.801261 9.055194 -6556 1776 4 0 -11.672865 13.689974 8.877182 -6557 1776 4 0 -11.032167 12.415049 8.150138 -6558 1777 6 0 13.406197 0.438838 6.515611 -6559 1777 4 0 12.971912 1.148987 7.055731 -6560 1777 4 0 13.378188 0.782754 5.596959 -6561 1778 6 0 16.121687 13.290724 10.280494 -6562 1778 4 0 16.894647 12.756757 10.507582 -6563 1778 4 0 15.529920 12.609242 9.885455 -6564 1779 6 0 1.591126 8.482167 4.697447 -6565 1779 4 0 1.970540 9.119397 4.113006 -6566 1779 4 0 2.267655 8.435325 5.388951 -6567 1780 6 0 -17.696505 1.721021 10.517174 -6568 1780 4 0 -17.885845 2.645526 10.594973 -6569 1780 4 0 -18.179500 1.418546 11.298333 -6570 1781 6 0 -1.148874 9.889607 17.693251 -6571 1781 4 0 -0.454725 10.039896 17.084647 -6572 1781 4 0 -1.617929 9.083378 17.328962 -6573 1782 6 0 -9.511269 -11.292655 15.803762 -6574 1782 4 0 -10.218255 -10.722353 16.196307 -6575 1782 4 0 -9.799298 -12.212118 15.932439 -6576 1783 6 0 -15.065889 16.639418 -8.067448 -6577 1783 4 0 -15.835102 17.201609 -8.362394 -6578 1783 4 0 -15.172025 15.753046 -8.516586 -6579 1784 6 0 -22.136814 -17.146244 -13.973167 -6580 1784 4 0 -21.367059 -16.850746 -13.432779 -6581 1784 4 0 -22.384487 -16.427789 -14.634859 -6582 1785 6 0 7.866282 -10.293632 -17.800934 -6583 1785 4 0 7.775951 -11.047150 -17.161148 -6584 1785 4 0 8.173086 -9.555520 -17.163954 -6585 1786 6 0 -11.457596 -0.574420 15.816493 -6586 1786 4 0 -11.795621 0.320073 15.789591 -6587 1786 4 0 -10.561019 -0.510839 15.442995 -6588 1787 6 0 20.020980 -12.359468 -8.719780 -6589 1787 4 0 20.891102 -12.503083 -8.310836 -6590 1787 4 0 19.657638 -11.746384 -8.095286 -6591 1788 6 0 -11.584374 -20.453145 18.626549 -6592 1788 4 0 -11.940173 -20.540398 19.531255 -6593 1788 4 0 -12.005638 -21.078955 18.029825 -6594 1789 6 0 3.431174 19.121516 18.407979 -6595 1789 4 0 3.226206 20.056373 18.426687 -6596 1789 4 0 2.600881 18.679871 18.370259 -6597 1790 6 0 -13.315767 -3.798762 16.329856 -6598 1790 4 0 -13.096103 -4.569637 15.670760 -6599 1790 4 0 -12.649730 -3.801668 17.013121 -6600 1791 6 0 7.563392 -5.518546 10.504795 -6601 1791 4 0 6.706770 -5.750354 10.096728 -6602 1791 4 0 7.922512 -6.417021 10.555834 -6603 1792 6 0 -18.725820 19.110329 -7.091283 -6604 1792 4 0 -19.518142 19.318716 -7.662306 -6605 1792 4 0 -18.568680 19.881279 -6.590714 -6606 1793 6 0 -1.414023 -16.961715 12.639857 -6607 1793 4 0 -1.328118 -15.968577 12.668980 -6608 1793 4 0 -1.076983 -17.347672 11.778245 -6609 1794 6 0 -23.307644 10.461811 -20.820802 -6610 1794 4 0 -23.561946 9.673912 -20.318452 -6611 1794 4 0 -24.099105 10.583838 -21.379713 -6612 1795 6 0 18.109258 -13.123924 17.182346 -6613 1795 4 0 19.074027 -13.199454 16.973877 -6614 1795 4 0 17.765173 -12.302968 16.728002 -6615 1796 6 0 21.683386 18.223931 -5.030005 -6616 1796 4 0 22.567099 18.027021 -5.437892 -6617 1796 4 0 21.636745 17.754335 -4.163593 -6618 1797 6 0 25.055072 19.034839 -7.681292 -6619 1797 4 0 24.766294 18.344263 -7.038060 -6620 1797 4 0 25.882695 18.757787 -7.948244 -6621 1798 6 0 15.570913 13.019010 5.553904 -6622 1798 4 0 15.992685 13.329314 6.362922 -6623 1798 4 0 15.449140 12.068146 5.738277 -6624 1799 6 0 -0.520016 -0.269780 14.795928 -6625 1799 4 0 -0.180326 -0.456884 15.694661 -6626 1799 4 0 -1.219092 -0.915185 14.727056 -6627 1800 6 0 1.663902 -15.429144 -10.527250 -6628 1800 4 0 2.554915 -15.533567 -10.136462 -6629 1800 4 0 1.815948 -15.297258 -11.416174 -6630 1801 6 0 -22.648336 -4.623238 -12.225694 -6631 1801 4 0 -23.412412 -4.010770 -12.025660 -6632 1801 4 0 -21.872894 -4.224451 -11.815463 -6633 1802 6 0 -2.279585 -20.867759 -19.023308 -6634 1802 4 0 -3.100549 -20.369345 -19.314139 -6635 1802 4 0 -1.811469 -21.235753 -19.767859 -6636 1803 6 0 -22.243475 -13.329179 -1.390694 -6637 1803 4 0 -22.862810 -12.659332 -1.686427 -6638 1803 4 0 -22.410657 -13.599367 -0.469217 -6639 1804 6 0 23.607826 -9.844602 16.352810 -6640 1804 4 0 24.370141 -9.837102 16.979270 -6641 1804 4 0 22.885616 -9.527980 16.925581 -6642 1805 6 0 -17.460421 9.171816 -11.938616 -6643 1805 4 0 -18.218389 8.865436 -11.398928 -6644 1805 4 0 -17.867876 9.968898 -12.335632 -6645 1806 6 0 2.263863 -17.526491 14.554618 -6646 1806 4 0 1.859635 -17.896680 15.358713 -6647 1806 4 0 2.052535 -18.087323 13.764230 -6648 1807 6 0 27.368617 -13.116454 -17.139830 -6649 1807 4 0 27.233784 -13.465846 -16.264251 -6650 1807 4 0 27.362385 -13.865254 -17.806940 -6651 1808 6 0 16.784972 2.549591 14.309398 -6652 1808 4 0 17.733190 2.537919 14.322805 -6653 1808 4 0 16.413277 1.810095 13.861707 -6654 1809 6 0 21.804761 -2.107242 -5.095741 -6655 1809 4 0 22.776789 -2.281899 -4.959560 -6656 1809 4 0 21.413198 -2.898127 -5.388708 -6657 1810 6 0 14.063924 6.483674 -0.351431 -6658 1810 4 0 14.941176 6.100507 -0.517796 -6659 1810 4 0 14.071859 7.050391 0.399753 -6660 1811 6 0 14.554835 16.507491 9.329558 -6661 1811 4 0 15.358643 16.591416 9.875030 -6662 1811 4 0 13.889851 17.088326 9.657109 -6663 1812 6 0 8.670655 -18.428515 -11.354395 -6664 1812 4 0 9.496711 -18.254251 -11.776580 -6665 1812 4 0 8.693110 -18.508570 -10.379319 -6666 1813 6 0 -17.333287 2.077059 19.999340 -6667 1813 4 0 -18.012974 2.265838 19.359237 -6668 1813 4 0 -17.678958 2.658724 20.686523 -6669 1814 6 0 -12.269943 7.557325 8.022561 -6670 1814 4 0 -11.782231 7.901385 7.310410 -6671 1814 4 0 -11.518722 7.369844 8.741429 -6672 1815 6 0 -16.422160 -12.244301 6.857276 -6673 1815 4 0 -16.476236 -12.690789 7.708566 -6674 1815 4 0 -17.265810 -12.438972 6.474023 -6675 1816 6 0 -12.460293 15.701651 -2.123616 -6676 1816 4 0 -12.202263 16.633440 -2.262429 -6677 1816 4 0 -12.915395 15.335750 -2.913659 -6678 1817 6 0 19.857137 7.435921 -19.855513 -6679 1817 4 0 19.224411 8.121790 -20.149860 -6680 1817 4 0 19.459580 7.115365 -18.985221 -6681 1818 6 0 27.414938 3.220691 12.551587 -6682 1818 4 0 28.302084 3.292286 12.082110 -6683 1818 4 0 27.376652 2.288121 12.758098 -6684 1819 6 0 -20.578446 6.501862 -7.543872 -6685 1819 4 0 -21.322455 7.133983 -7.483478 -6686 1819 4 0 -20.905164 5.709027 -7.068017 -6687 1820 6 0 9.893421 -13.954239 -2.145744 -6688 1820 4 0 10.845577 -13.887452 -1.806008 -6689 1820 4 0 9.670044 -13.100245 -2.522670 -6690 1821 6 0 -4.428072 -19.794959 6.392084 -6691 1821 4 0 -3.499634 -19.499125 6.457248 -6692 1821 4 0 -4.796122 -19.302160 7.159538 -6693 1822 6 0 -7.874919 11.488098 -11.872687 -6694 1822 4 0 -7.741906 10.850602 -11.130468 -6695 1822 4 0 -8.663122 11.156415 -12.262641 -6696 1823 6 0 25.941607 -13.435898 9.799183 -6697 1823 4 0 26.834803 -13.623931 10.154795 -6698 1823 4 0 25.332757 -14.073159 10.291155 -6699 1824 6 0 -19.551589 -5.315854 19.441555 -6700 1824 4 0 -19.573638 -5.247652 20.432003 -6701 1824 4 0 -18.874142 -4.641904 19.223175 -6702 1825 6 0 -15.895156 17.865430 12.295752 -6703 1825 4 0 -15.942604 18.800693 12.596548 -6704 1825 4 0 -16.548061 17.362585 12.771509 -6705 1826 6 0 2.671083 -14.766415 2.401009 -6706 1826 4 0 1.987603 -14.345575 1.847880 -6707 1826 4 0 2.531547 -14.517967 3.328895 -6708 1827 6 0 12.335851 -9.704468 -20.394740 -6709 1827 4 0 12.648806 -9.830295 -19.492670 -6710 1827 4 0 11.490958 -10.100623 -20.194535 -6711 1828 6 0 -22.106737 -9.538400 8.455985 -6712 1828 4 0 -21.536209 -9.084366 9.058590 -6713 1828 4 0 -23.017732 -9.207212 8.501551 -6714 1829 6 0 12.648535 6.444583 -9.932281 -6715 1829 4 0 13.157813 6.358331 -10.726454 -6716 1829 4 0 11.747411 6.253342 -10.180418 -6717 1830 6 0 -13.625525 -14.166725 14.041460 -6718 1830 4 0 -13.177614 -14.592522 13.259629 -6719 1830 4 0 -14.592492 -14.334369 13.940732 -6720 1831 6 0 6.601614 16.498956 -16.461129 -6721 1831 4 0 7.358480 15.895066 -16.451685 -6722 1831 4 0 6.023786 16.041896 -17.084703 -6723 1832 6 0 21.778571 -2.612574 13.360688 -6724 1832 4 0 22.384822 -2.519802 12.682789 -6725 1832 4 0 21.622799 -1.672884 13.624001 -6726 1833 6 0 -20.149213 6.013192 6.945622 -6727 1833 4 0 -21.145473 5.909263 6.918876 -6728 1833 4 0 -19.835482 6.282517 6.065703 -6729 1834 6 0 -21.966774 -11.494919 -8.738743 -6730 1834 4 0 -22.851768 -11.211695 -9.113733 -6731 1834 4 0 -21.879165 -10.921961 -8.012191 -6732 1835 6 0 15.449095 -9.497086 12.201305 -6733 1835 4 0 16.382306 -9.836986 12.244632 -6734 1835 4 0 15.422419 -9.084200 11.356115 -6735 1836 6 0 12.664756 -15.306651 -20.531836 -6736 1836 4 0 12.034408 -16.012414 -20.359938 -6737 1836 4 0 12.739209 -14.577278 -19.974973 -6738 1837 6 0 -7.972869 -5.604918 -11.934405 -6739 1837 4 0 -7.601267 -4.885318 -11.379446 -6740 1837 4 0 -8.575310 -6.063681 -11.263704 -6741 1838 6 0 0.299553 12.700530 -18.524181 -6742 1838 4 0 0.558430 11.815355 -18.777046 -6743 1838 4 0 -0.711668 12.618485 -18.481012 -6744 1839 6 0 -0.824908 18.918494 -20.332651 -6745 1839 4 0 0.055729 18.800950 -20.088514 -6746 1839 4 0 -0.726815 18.736133 -21.275575 -6747 1840 6 0 25.716218 -17.621624 -18.165089 -6748 1840 4 0 25.183585 -18.348327 -18.615572 -6749 1840 4 0 26.570805 -18.051277 -17.821631 -6750 1841 6 0 11.895246 -12.886376 -15.030415 -6751 1841 4 0 12.581969 -12.241572 -14.789572 -6752 1841 4 0 12.014494 -13.590976 -14.363464 -6753 1842 6 0 -6.984781 -6.050242 10.699580 -6754 1842 4 0 -6.200372 -6.230567 10.144341 -6755 1842 4 0 -6.715278 -5.563587 11.454374 -6756 1843 6 0 -7.335609 -12.055455 -4.954546 -6757 1843 4 0 -6.870389 -12.537029 -5.731051 -6758 1843 4 0 -8.034369 -11.614893 -5.410536 -6759 1844 6 0 7.328653 12.351276 10.622525 -6760 1844 4 0 7.205722 12.826673 9.764783 -6761 1844 4 0 6.491360 12.585679 11.094427 -6762 1845 6 0 -2.064418 15.964062 4.897369 -6763 1845 4 0 -1.989044 16.110456 3.944429 -6764 1845 4 0 -1.188158 16.010465 5.256453 -6765 1846 6 0 10.673140 16.947190 -7.298199 -6766 1846 4 0 11.053321 16.848368 -6.437645 -6767 1846 4 0 9.833705 16.415071 -7.530378 -6768 1847 6 0 25.146955 -10.850377 -5.894794 -6769 1847 4 0 25.793466 -10.144367 -5.792885 -6770 1847 4 0 25.341761 -11.315139 -6.748470 -6771 1848 6 0 -20.898709 -20.024244 -0.432532 -6772 1848 4 0 -21.327485 -20.809324 -0.731327 -6773 1848 4 0 -20.384646 -19.736744 -1.159428 -6774 1849 6 0 15.773125 -11.828239 1.267979 -6775 1849 4 0 15.082308 -11.485912 1.791000 -6776 1849 4 0 16.210809 -11.047975 0.843250 -6777 1850 6 0 -25.459831 -14.049130 16.602221 -6778 1850 4 0 -25.659268 -15.033606 16.753032 -6779 1850 4 0 -26.167299 -13.609133 17.155971 -6780 1851 6 0 -15.346212 9.776118 0.552706 -6781 1851 4 0 -14.861031 10.583944 0.897097 -6782 1851 4 0 -15.499398 9.230659 1.360288 -6783 1852 6 0 1.515239 -10.027493 16.408903 -6784 1852 4 0 2.112245 -9.685145 15.772127 -6785 1852 4 0 1.563862 -10.961534 16.268707 -6786 1853 6 0 8.730778 -2.046469 -16.855487 -6787 1853 4 0 8.003213 -2.349766 -16.293070 -6788 1853 4 0 8.893912 -1.127143 -16.700440 -6789 1854 6 0 -12.659858 10.277753 9.764551 -6790 1854 4 0 -12.954976 10.194740 10.671493 -6791 1854 4 0 -12.294313 11.185370 9.686563 -6792 1855 6 0 13.241019 7.614156 1.958471 -6793 1855 4 0 13.989186 7.821908 2.548064 -6794 1855 4 0 12.569506 7.225025 2.564990 -6795 1856 6 0 18.743445 -1.851686 14.221199 -6796 1856 4 0 19.241705 -2.155912 15.013052 -6797 1856 4 0 17.934973 -2.360999 14.283218 -6798 1857 6 0 20.097738 14.045420 -3.353931 -6799 1857 4 0 20.264111 13.632005 -4.240012 -6800 1857 4 0 19.782670 14.876950 -3.580329 -6801 1858 6 0 22.656523 -13.025771 -7.851202 -6802 1858 4 0 23.058494 -13.682024 -8.427211 -6803 1858 4 0 22.939496 -13.206983 -6.927788 -6804 1859 6 0 22.687429 4.701978 5.232797 -6805 1859 4 0 22.127391 3.970799 5.568822 -6806 1859 4 0 22.543397 5.316387 5.948219 -6807 1860 6 0 23.649228 -7.915795 -3.510236 -6808 1860 4 0 22.801078 -8.238516 -3.339971 -6809 1860 4 0 23.474938 -7.503073 -4.391727 -6810 1861 6 0 -6.616017 -20.555130 17.274390 -6811 1861 4 0 -6.785872 -19.593361 17.044755 -6812 1861 4 0 -6.639098 -20.935653 16.386762 -6813 1862 6 0 11.575769 10.993842 8.632733 -6814 1862 4 0 11.631285 10.248287 9.251562 -6815 1862 4 0 11.054687 11.776369 9.032913 -6816 1863 6 0 -14.897591 -13.741408 -8.424343 -6817 1863 4 0 -13.944044 -13.521919 -8.374624 -6818 1863 4 0 -15.245652 -13.416716 -9.247098 -6819 1864 6 0 -7.606286 -16.239672 5.296165 -6820 1864 4 0 -8.529013 -16.377754 5.125689 -6821 1864 4 0 -7.372109 -15.298609 5.089587 -6822 1865 6 0 21.651688 -6.687757 -17.914010 -6823 1865 4 0 21.631109 -7.371723 -17.250699 -6824 1865 4 0 22.595382 -6.421930 -17.913376 -6825 1866 6 0 8.244086 -0.418132 8.413538 -6826 1866 4 0 8.150004 -1.042562 7.678730 -6827 1866 4 0 7.835426 -0.797019 9.189825 -6828 1867 6 0 16.479760 -10.801798 -19.696932 -6829 1867 4 0 17.075192 -11.093875 -20.402321 -6830 1867 4 0 17.056365 -10.719762 -18.940382 -6831 1868 6 0 -0.277774 0.459271 -13.592265 -6832 1868 4 0 0.641958 0.154550 -13.512461 -6833 1868 4 0 -0.452113 1.346343 -13.286369 -6834 1869 6 0 -6.542284 15.376168 4.177517 -6835 1869 4 0 -5.816160 15.112821 4.810192 -6836 1869 4 0 -6.899831 14.592226 3.628797 -6837 1870 6 0 -20.635866 7.001713 -1.480479 -6838 1870 4 0 -21.373222 6.994284 -2.078088 -6839 1870 4 0 -20.006067 6.359671 -1.951231 -6840 1871 6 0 -13.639335 3.376760 17.002766 -6841 1871 4 0 -13.969979 2.665180 17.593575 -6842 1871 4 0 -13.046017 3.905659 17.530455 -6843 1872 6 0 -6.547337 20.684985 14.541933 -6844 1872 4 0 -6.972273 21.348698 14.071679 -6845 1872 4 0 -5.602331 20.918763 14.522709 -6846 1873 6 0 -2.497800 -13.782262 -4.791828 -6847 1873 4 0 -1.576617 -13.507624 -4.869174 -6848 1873 4 0 -2.714797 -14.013702 -5.709334 -6849 1874 6 0 -1.112625 18.563757 18.790030 -6850 1874 4 0 -0.288236 18.142534 18.527379 -6851 1874 4 0 -0.946536 19.452779 18.744542 -6852 1875 6 0 -13.988854 -2.769276 -13.122084 -6853 1875 4 0 -13.598926 -2.700606 -13.943868 -6854 1875 4 0 -14.937873 -2.607884 -13.208114 -6855 1876 6 0 -16.715661 8.750744 -17.681497 -6856 1876 4 0 -15.798116 8.603619 -18.047851 -6857 1876 4 0 -16.635460 9.420085 -17.000771 -6858 1877 6 0 2.991113 -12.748536 9.631899 -6859 1877 4 0 2.533802 -13.278079 8.996870 -6860 1877 4 0 2.583180 -11.923543 9.637997 -6861 1878 6 0 -27.414426 -12.634511 18.337817 -6862 1878 4 0 -28.225666 -12.744824 17.838871 -6863 1878 4 0 -27.706128 -12.906300 19.286418 -6864 1879 6 0 11.850131 -20.736745 10.117226 -6865 1879 4 0 12.209918 -19.885422 9.990598 -6866 1879 4 0 12.449458 -21.164159 10.776006 -6867 1880 6 0 16.900404 -9.611117 0.299881 -6868 1880 4 0 17.702920 -9.200486 0.626455 -6869 1880 4 0 16.211832 -8.949525 0.285394 -6870 1881 6 0 1.300636 17.476583 -19.357702 -6871 1881 4 0 1.244601 16.535623 -19.680589 -6872 1881 4 0 2.229065 17.802299 -19.528512 -6873 1882 6 0 -13.442641 6.855380 -12.602329 -6874 1882 4 0 -13.248683 5.960155 -12.345808 -6875 1882 4 0 -12.964930 7.379163 -11.927446 -6876 1883 6 0 10.508692 10.781998 13.857653 -6877 1883 4 0 10.700750 11.227397 13.025331 -6878 1883 4 0 11.274159 10.169036 14.047871 -6879 1884 6 0 -15.161111 15.497808 -1.075417 -6880 1884 4 0 -14.941306 16.067302 -1.834212 -6881 1884 4 0 -14.307102 15.425376 -0.587763 -6882 1885 6 0 26.516448 19.605204 -1.401155 -6883 1885 4 0 27.409955 19.971686 -1.420282 -6884 1885 4 0 26.420947 18.971191 -0.667802 -6885 1886 6 0 -0.954004 8.187819 13.771505 -6886 1886 4 0 -0.458409 7.469182 14.137804 -6887 1886 4 0 -1.797548 7.882182 13.530929 -6888 1887 6 0 15.694940 -16.566561 10.671838 -6889 1887 4 0 15.180482 -16.576742 9.844033 -6890 1887 4 0 14.966563 -16.548505 11.318780 -6891 1888 6 0 18.598747 3.441754 -19.980603 -6892 1888 4 0 19.607131 3.445422 -19.714075 -6893 1888 4 0 18.629619 3.587760 -20.937873 -6894 1889 6 0 -4.101725 20.626483 18.518698 -6895 1889 4 0 -4.832741 21.173287 18.195756 -6896 1889 4 0 -3.506641 21.284151 19.004490 -6897 1890 6 0 -1.622747 20.903759 -10.623135 -6898 1890 4 0 -1.749055 20.907257 -9.665824 -6899 1890 4 0 -2.518273 20.806241 -11.004696 -6900 1891 6 0 -2.179807 -14.291095 -12.926864 -6901 1891 4 0 -2.705153 -14.473812 -12.111290 -6902 1891 4 0 -1.495280 -13.773858 -12.562680 -6903 1892 6 0 -21.678830 15.695505 11.326422 -6904 1892 4 0 -21.490132 16.123832 12.219822 -6905 1892 4 0 -22.555374 16.000330 11.105890 -6906 1893 6 0 20.387528 -15.104299 -14.428654 -6907 1893 4 0 19.639614 -14.550582 -14.652181 -6908 1893 4 0 20.966724 -14.615439 -13.782083 -6909 1894 6 0 8.543989 2.061633 14.171285 -6910 1894 4 0 8.138366 1.205164 14.195988 -6911 1894 4 0 8.018048 2.600851 14.790181 -6912 1895 6 0 -14.889828 7.565748 -1.232224 -6913 1895 4 0 -15.277980 8.149588 -0.532147 -6914 1895 4 0 -14.157076 7.163538 -0.720742 -6915 1896 6 0 6.890439 6.835565 10.786892 -6916 1896 4 0 7.316224 7.702174 10.597929 -6917 1896 4 0 7.041785 6.699181 11.734956 -6918 1897 6 0 -23.725715 6.589830 20.135978 -6919 1897 4 0 -24.326282 5.920341 20.500508 -6920 1897 4 0 -24.274788 7.300563 19.971121 -6921 1898 6 0 -0.448883 -20.864583 -14.617458 -6922 1898 4 0 0.071192 -21.697111 -14.370110 -6923 1898 4 0 -0.336801 -20.602783 -15.491876 -6924 1899 6 0 4.752131 -18.759171 16.224472 -6925 1899 4 0 4.247100 -17.909089 16.159151 -6926 1899 4 0 5.497199 -18.596379 16.767517 -6927 1900 6 0 25.551466 11.024091 14.835821 -6928 1900 4 0 26.097565 10.360826 15.318240 -6929 1900 4 0 25.868265 11.894670 15.113284 -6930 1901 6 0 -13.792632 -0.131648 -11.968031 -6931 1901 4 0 -14.069742 -1.037349 -12.273373 -6932 1901 4 0 -14.587746 0.465719 -12.016945 -6933 1902 6 0 -2.710690 15.293627 -0.278680 -6934 1902 4 0 -2.998969 15.960057 0.331443 -6935 1902 4 0 -3.386842 14.623069 -0.355634 -6936 1903 6 0 -17.248233 -20.121844 -4.059452 -6937 1903 4 0 -17.172414 -21.044463 -4.251654 -6938 1903 4 0 -16.877225 -20.034684 -3.174803 -6939 1904 6 0 23.843575 9.736974 -14.350198 -6940 1904 4 0 23.682322 8.979239 -15.046519 -6941 1904 4 0 23.367386 9.481782 -13.520758 -6942 1905 6 0 -11.977920 -13.866924 -9.096345 -6943 1905 4 0 -12.034457 -14.762049 -8.738542 -6944 1905 4 0 -11.033924 -13.842490 -9.319192 -6945 1906 6 0 -20.844885 -20.673768 11.904219 -6946 1906 4 0 -21.211544 -21.565612 12.158518 -6947 1906 4 0 -21.251746 -20.526654 11.038182 -6948 1907 6 0 10.501648 -10.083276 10.087293 -6949 1907 4 0 10.918566 -9.250606 10.394612 -6950 1907 4 0 9.992333 -9.906650 9.274003 -6951 1908 6 0 -19.115579 -4.779064 -19.789173 -6952 1908 4 0 -18.214269 -4.399767 -19.923178 -6953 1908 4 0 -19.400662 -4.666966 -18.902157 -6954 1909 6 0 27.292959 4.591920 -14.450094 -6955 1909 4 0 27.857326 4.638750 -13.673258 -6956 1909 4 0 26.302663 4.467257 -14.132617 -6957 1910 6 0 -15.973482 -19.623868 10.652463 -6958 1910 4 0 -15.396164 -19.929927 9.974366 -6959 1910 4 0 -16.843194 -19.544182 10.235192 -6960 1911 6 0 -24.224954 -2.728737 10.935846 -6961 1911 4 0 -23.262685 -2.710705 11.036848 -6962 1911 4 0 -24.594330 -3.621981 10.847310 -6963 1912 6 0 -10.392772 -14.962488 2.206954 -6964 1912 4 0 -10.142273 -15.819733 2.617268 -6965 1912 4 0 -9.689412 -14.869628 1.550246 -6966 1913 6 0 23.781651 14.549010 -15.425504 -6967 1913 4 0 23.508500 15.178591 -16.172525 -6968 1913 4 0 23.231402 13.779403 -15.566088 -6969 1914 6 0 -16.655122 13.378532 -2.256893 -6970 1914 4 0 -15.876557 13.842392 -1.809556 -6971 1914 4 0 -17.352965 14.010234 -2.115536 -6972 1915 6 0 17.907598 17.234287 -12.510154 -6973 1915 4 0 17.700495 16.802779 -13.342124 -6974 1915 4 0 17.297348 17.961204 -12.489351 -6975 1916 6 0 17.427023 -12.078823 9.916700 -6976 1916 4 0 16.525879 -12.070244 9.636554 -6977 1916 4 0 17.909679 -12.239509 9.119337 -6978 1917 6 0 -19.359847 6.057050 19.624868 -6979 1917 4 0 -19.814369 5.574360 18.904014 -6980 1917 4 0 -19.255770 6.911903 19.182635 -6981 1918 6 0 18.674024 -19.624270 17.522963 -6982 1918 4 0 17.740156 -19.461855 17.682137 -6983 1918 4 0 18.867385 -19.535332 16.599150 -6984 1919 6 0 20.025827 3.814045 -9.622919 -6985 1919 4 0 19.683972 4.038069 -10.485997 -6986 1919 4 0 20.937506 3.543209 -9.811005 -6987 1920 6 0 5.470940 6.984171 8.109869 -6988 1920 4 0 5.850717 7.846581 8.087996 -6989 1920 4 0 5.945843 6.559192 8.827716 -6990 1921 6 0 -10.808039 20.531242 -16.312076 -6991 1921 4 0 -10.302470 21.104206 -15.760708 -6992 1921 4 0 -10.017446 20.227222 -16.784699 -6993 1922 6 0 -11.027875 -4.920821 17.870938 -6994 1922 4 0 -10.325336 -4.445713 17.369166 -6995 1922 4 0 -11.377886 -5.529192 17.224974 -6996 1923 6 0 -20.371671 10.114815 16.255481 -6997 1923 4 0 -20.580138 10.101355 15.263993 -6998 1923 4 0 -20.344545 11.071578 16.437819 -6999 1924 6 0 23.653520 3.436168 1.325510 -7000 1924 4 0 23.536106 2.474980 1.098717 -7001 1924 4 0 23.860683 3.796523 0.414552 -7002 1925 6 0 -21.567514 -2.949387 5.091162 -7003 1925 4 0 -22.071317 -3.738968 4.916553 -7004 1925 4 0 -22.336939 -2.390166 5.390630 -7005 1926 6 0 22.554166 -9.402044 -6.100872 -7006 1926 4 0 23.431323 -9.766839 -6.077907 -7007 1926 4 0 22.697180 -8.479613 -6.418284 -7008 1927 6 0 -22.569113 -4.640399 13.826281 -7009 1927 4 0 -23.358557 -5.049193 13.550678 -7010 1927 4 0 -22.257880 -5.191735 14.515317 -7011 1928 6 0 -2.385157 12.751460 -2.313524 -7012 1928 4 0 -1.730031 13.357140 -2.644514 -7013 1928 4 0 -1.978595 12.282671 -1.585523 -7014 1929 6 0 -26.161645 14.565358 1.232440 -7015 1929 4 0 -26.706603 13.814255 1.347347 -7016 1929 4 0 -26.622850 15.329972 1.567273 -7017 1930 6 0 1.453589 -9.489501 -18.511074 -7018 1930 4 0 1.470127 -10.349425 -18.991155 -7019 1930 4 0 1.973543 -8.965754 -19.091787 -7020 1931 6 0 -0.660378 -18.577536 -12.938447 -7021 1931 4 0 -0.732583 -19.053338 -12.113581 -7022 1931 4 0 -0.517701 -19.272917 -13.578982 -7023 1932 6 0 14.312654 12.150861 -6.246651 -7024 1932 4 0 14.287806 12.704737 -5.491569 -7025 1932 4 0 15.175580 11.801455 -6.299294 -7026 1933 6 0 18.998590 6.532260 -0.632888 -7027 1933 4 0 18.366049 5.787028 -0.799484 -7028 1933 4 0 19.311853 6.485139 0.272589 -7029 1934 6 0 5.329915 17.883588 20.342830 -7030 1934 4 0 4.796701 18.410992 19.709020 -7031 1934 4 0 4.770971 17.852635 21.154570 -7032 1935 6 0 24.723592 -6.944303 -11.741165 -7033 1935 4 0 24.780327 -6.008688 -11.867155 -7034 1935 4 0 24.690407 -7.329055 -12.639425 -7035 1936 6 0 -23.122003 4.618796 18.181339 -7036 1936 4 0 -23.209287 5.265752 18.869409 -7037 1936 4 0 -23.988906 4.549652 17.803581 -7038 1937 6 0 8.709146 17.478249 5.929770 -7039 1937 4 0 7.992855 18.166454 5.872705 -7040 1937 4 0 9.532770 18.014027 5.879190 -7041 1938 6 0 -25.145193 10.967387 14.467030 -7042 1938 4 0 -25.638192 11.462461 13.811080 -7043 1938 4 0 -25.115880 11.602045 15.194844 -7044 1939 6 0 -6.270672 10.298692 -9.326284 -7045 1939 4 0 -6.326041 9.841909 -8.460997 -7046 1939 4 0 -5.298295 10.155581 -9.629880 -7047 1940 6 0 8.331282 15.667208 -4.044961 -7048 1940 4 0 8.081425 16.068754 -3.248975 -7049 1940 4 0 7.784433 16.176579 -4.661216 -7050 1941 6 0 -4.605111 3.075866 17.330627 -7051 1941 4 0 -4.999875 2.960715 16.481841 -7052 1941 4 0 -5.159040 3.212840 18.083160 -7053 1942 6 0 14.687017 -3.513814 10.903431 -7054 1942 4 0 14.499277 -3.337699 11.823116 -7055 1942 4 0 14.262838 -4.331541 10.602044 -7056 1943 6 0 -20.872612 6.379762 10.816794 -7057 1943 4 0 -20.860809 7.234769 10.341581 -7058 1943 4 0 -20.061300 6.341520 11.384808 -7059 1944 6 0 7.161896 -4.360755 17.634105 -7060 1944 4 0 8.175987 -4.400233 17.464973 -7061 1944 4 0 7.057446 -4.853463 18.480499 -7062 1945 6 0 -3.475038 11.316770 16.798166 -7063 1945 4 0 -2.755042 10.845936 17.155120 -7064 1945 4 0 -3.489190 11.054731 15.856176 -7065 1946 6 0 15.663266 8.649743 3.198716 -7066 1946 4 0 15.359027 9.298705 3.810376 -7067 1946 4 0 16.192400 8.008866 3.672568 -7068 1947 6 0 5.436707 -20.461241 11.921265 -7069 1947 4 0 5.119701 -19.606856 11.530637 -7070 1947 4 0 4.713208 -20.630626 12.549382 -7071 1948 6 0 -4.801212 -17.868960 -3.936676 -7072 1948 4 0 -5.438715 -17.659702 -4.657529 -7073 1948 4 0 -4.229156 -18.589597 -4.194370 -7074 1949 6 0 -15.253442 11.238290 -10.212163 -7075 1949 4 0 -14.642285 11.918974 -10.588009 -7076 1949 4 0 -16.099309 11.643007 -10.393989 -7077 1950 6 0 26.686176 10.830985 20.584564 -7078 1950 4 0 26.369951 11.360874 21.358365 -7079 1950 4 0 26.509688 9.944710 20.906243 -7080 1951 6 0 12.561683 17.569279 18.161912 -7081 1951 4 0 12.373224 16.635553 17.927044 -7082 1951 4 0 11.953579 17.940076 18.749558 -7083 1952 6 0 -7.212093 -10.307008 17.334494 -7084 1952 4 0 -6.512620 -10.511909 17.944932 -7085 1952 4 0 -7.614860 -11.144180 17.014381 -7086 1953 6 0 1.066613 3.381658 18.538737 -7087 1953 4 0 1.472142 3.810443 19.302366 -7088 1953 4 0 0.121217 3.213227 18.686468 -7089 1954 6 0 26.591569 20.388220 15.314096 -7090 1954 4 0 27.027629 19.549241 15.003737 -7091 1954 4 0 25.677162 20.106742 15.492223 -7092 1955 6 0 -12.980829 3.037173 -5.149300 -7093 1955 4 0 -13.518049 2.271141 -5.381098 -7094 1955 4 0 -13.015144 3.271986 -4.233059 -7095 1956 6 0 -15.670290 -19.461795 -8.693893 -7096 1956 4 0 -15.312346 -19.371467 -7.762922 -7097 1956 4 0 -15.700912 -18.579237 -9.112271 -7098 1957 6 0 18.498310 -6.951013 11.923309 -7099 1957 4 0 19.331146 -6.980278 12.293062 -7100 1957 4 0 17.952458 -6.708175 12.679535 -7101 1958 6 0 22.848965 14.115566 0.206953 -7102 1958 4 0 23.127347 14.768732 -0.415947 -7103 1958 4 0 23.434401 14.218348 0.991573 -7104 1959 6 0 -23.977260 16.643521 -8.138268 -7105 1959 4 0 -24.563932 16.858836 -8.896849 -7106 1959 4 0 -23.095154 16.760370 -8.386216 -7107 1960 6 0 -26.584391 -6.397854 5.547650 -7108 1960 4 0 -25.925294 -7.061435 5.741608 -7109 1960 4 0 -26.133892 -5.544387 5.442967 -7110 1961 6 0 2.060216 -10.468459 10.640375 -7111 1961 4 0 2.489904 -9.711105 10.219505 -7112 1961 4 0 1.131111 -10.283322 10.616360 -7113 1962 6 0 5.954667 9.758583 -20.555530 -7114 1962 4 0 6.264304 10.543474 -21.120622 -7115 1962 4 0 5.484413 9.147185 -21.197897 -7116 1963 6 0 24.786566 -15.292270 2.666103 -7117 1963 4 0 23.947578 -15.213745 2.181575 -7118 1963 4 0 24.621364 -16.114647 3.180504 -7119 1964 6 0 -9.238549 4.246640 18.608373 -7120 1964 4 0 -8.516205 4.915950 18.512268 -7121 1964 4 0 -8.905672 3.343488 18.421048 -7122 1965 6 0 4.458783 0.783326 15.910622 -7123 1965 4 0 4.333357 -0.156607 15.829450 -7124 1965 4 0 5.377583 0.813141 16.228468 -7125 1966 6 0 2.440654 19.498822 -16.520052 -7126 1966 4 0 1.894281 18.987314 -15.882707 -7127 1966 4 0 2.550447 18.871750 -17.222238 -7128 1967 6 0 -14.387304 8.489545 5.108260 -7129 1967 4 0 -14.330824 9.314254 5.570879 -7130 1967 4 0 -13.611936 7.964241 5.306370 -7131 1968 6 0 -5.680779 -19.561928 -0.391390 -7132 1968 4 0 -6.492940 -19.118143 -0.731363 -7133 1968 4 0 -5.761503 -20.446667 -0.611520 -7134 1969 6 0 0.364483 -0.976730 20.596640 -7135 1969 4 0 0.190818 -1.943299 20.568078 -7136 1969 4 0 -0.296384 -0.570410 19.967598 -7137 1970 6 0 -20.103572 15.327950 -3.864750 -7138 1970 4 0 -20.721760 16.087200 -3.977948 -7139 1970 4 0 -19.620299 15.411599 -4.730333 -7140 1971 6 0 7.762229 -15.911349 -12.044815 -7141 1971 4 0 8.618390 -15.446157 -11.951239 -7142 1971 4 0 8.056718 -16.844883 -11.932849 -7143 1972 6 0 -14.271772 -19.114636 20.444087 -7144 1972 4 0 -13.631359 -18.451185 20.013255 -7145 1972 4 0 -14.788312 -18.613074 21.058254 -7146 1973 6 0 -17.296785 -16.270141 -5.846230 -7147 1973 4 0 -16.661324 -16.986407 -5.791657 -7148 1973 4 0 -17.698563 -16.270611 -6.699261 -7149 1974 6 0 5.461014 -17.908610 10.258639 -7150 1974 4 0 6.041339 -18.066045 9.495427 -7151 1974 4 0 5.907462 -17.113295 10.672048 -7152 1975 6 0 -6.579640 -20.864919 -3.728078 -7153 1975 4 0 -6.197014 -21.129682 -2.892954 -7154 1975 4 0 -5.867159 -20.529771 -4.364102 -7155 1976 6 0 15.290566 -16.899037 3.541007 -7156 1976 4 0 15.456923 -17.854501 3.506824 -7157 1976 4 0 14.682578 -16.661722 4.258103 -7158 1977 6 0 -8.595092 -1.638190 20.084084 -7159 1977 4 0 -8.261779 -2.590969 20.168832 -7160 1977 4 0 -7.852015 -1.108351 20.332316 -7161 1978 6 0 -20.323788 -5.436750 0.324161 -7162 1978 4 0 -20.170009 -5.941054 1.094644 -7163 1978 4 0 -21.208252 -5.031900 0.601954 -7164 1979 6 0 -2.393237 8.004242 -11.498413 -7165 1979 4 0 -2.950404 8.660356 -11.054135 -7166 1979 4 0 -3.061318 7.581791 -12.073133 -7167 1980 6 0 -22.912771 3.860494 -12.441206 -7168 1980 4 0 -23.451777 3.037762 -12.348507 -7169 1980 4 0 -22.899565 4.032930 -13.430208 -7170 1981 6 0 20.362995 17.824512 -13.264003 -7171 1981 4 0 19.551615 17.496626 -12.844707 -7172 1981 4 0 20.082478 18.300222 -14.079166 -7173 1982 6 0 -24.585913 -0.746630 -0.896798 -7174 1982 4 0 -24.470331 -1.075027 -1.802806 -7175 1982 4 0 -23.819676 -0.946255 -0.373167 -7176 1983 6 0 -19.535789 -9.056148 -13.988499 -7177 1983 4 0 -19.846462 -8.673779 -13.166776 -7178 1983 4 0 -19.115510 -8.309283 -14.534612 -7179 1984 6 0 14.390022 6.679518 12.730957 -7180 1984 4 0 15.232081 6.289813 12.946155 -7181 1984 4 0 14.506655 7.667961 12.798775 -7182 1985 6 0 -13.116074 -0.366672 20.319004 -7183 1985 4 0 -12.270792 -0.638533 19.918398 -7184 1985 4 0 -13.671647 -1.133311 20.295523 -7185 1986 6 0 -8.591511 -19.336122 8.863799 -7186 1986 4 0 -9.117090 -20.010877 8.426692 -7187 1986 4 0 -7.862918 -19.753372 9.330648 -7188 1987 6 0 17.402278 20.652639 13.900402 -7189 1987 4 0 17.697788 21.603581 13.957892 -7190 1987 4 0 17.312316 20.500438 12.944824 -7191 1988 6 0 8.201262 9.483818 13.348516 -7192 1988 4 0 7.444873 10.096390 13.607594 -7193 1988 4 0 8.957598 10.011937 13.627746 -7194 1989 6 0 7.585535 14.800848 -12.327563 -7195 1989 4 0 7.057327 14.353832 -11.664194 -7196 1989 4 0 7.019891 15.502887 -12.695142 -7197 1990 6 0 -25.423194 -2.683175 -19.281520 -7198 1990 4 0 -25.154720 -3.154251 -18.493055 -7199 1990 4 0 -24.615481 -2.633480 -19.773081 -7200 1991 6 0 19.725045 -13.114787 8.444878 -7201 1991 4 0 19.513124 -14.034339 8.634210 -7202 1991 4 0 20.698306 -13.102042 8.543928 -7203 1992 6 0 20.099503 -20.282525 -15.985101 -7204 1992 4 0 20.708189 -19.889578 -15.319196 -7205 1992 4 0 19.393142 -19.575319 -15.986140 -7206 1993 6 0 12.771061 16.100563 -19.111418 -7207 1993 4 0 12.131597 16.778356 -19.314806 -7208 1993 4 0 12.464661 15.303336 -19.572804 -7209 1994 6 0 7.091753 -14.703139 17.991009 -7210 1994 4 0 7.807603 -15.309333 17.938259 -7211 1994 4 0 7.194027 -14.118016 17.231754 -7212 1995 6 0 -22.592481 8.686176 -7.047127 -7213 1995 4 0 -22.216240 9.064017 -6.202984 -7214 1995 4 0 -23.491060 9.070100 -7.232883 -7215 1996 6 0 -4.638462 -13.691402 17.535113 -7216 1996 4 0 -4.741933 -14.552763 17.998987 -7217 1996 4 0 -3.917812 -13.768318 16.891949 -7218 1997 6 0 15.674081 -9.755387 -16.113189 -7219 1997 4 0 16.400378 -9.301702 -15.729512 -7220 1997 4 0 15.141124 -9.061926 -16.542582 -7221 1998 6 0 -13.702316 -19.909047 -12.268941 -7222 1998 4 0 -14.359478 -19.319853 -12.555858 -7223 1998 4 0 -14.123812 -20.688800 -11.912022 -7224 1999 6 0 24.541571 12.760808 8.882057 -7225 1999 4 0 24.177431 13.512218 9.353984 -7226 1999 4 0 24.288780 12.867460 7.942115 -7227 2000 6 0 -7.687548 20.108508 10.397741 -7228 2000 4 0 -6.786045 20.459581 10.465576 -7229 2000 4 0 -7.840032 19.590481 9.619893 -7230 2001 6 0 17.691564 14.211194 -11.948720 -7231 2001 4 0 16.837678 14.621970 -11.842799 -7232 2001 4 0 18.118330 14.755742 -12.626475 -7233 2002 6 0 21.348057 -7.329463 -13.375832 -7234 2002 4 0 21.593345 -6.492239 -13.815720 -7235 2002 4 0 21.736068 -7.343951 -12.513154 -7236 2003 6 0 -19.887601 4.039241 4.011716 -7237 2003 4 0 -20.804227 3.899388 4.382950 -7238 2003 4 0 -19.888370 5.029157 3.892591 -7239 2004 6 0 -25.084134 8.583682 -19.308703 -7240 2004 4 0 -25.512658 8.302589 -20.191094 -7241 2004 4 0 -24.552230 7.802502 -19.104750 -7242 2005 6 0 9.783143 -8.944234 15.919722 -7243 2005 4 0 9.846305 -9.847677 16.313657 -7244 2005 4 0 10.422901 -8.539313 16.532052 -7245 2006 6 0 24.921152 14.233454 -9.328043 -7246 2006 4 0 25.485037 14.435637 -8.538860 -7247 2006 4 0 24.550831 15.052607 -9.617520 -7248 2007 6 0 -5.336150 -19.944956 -15.675499 -7249 2007 4 0 -4.550070 -20.475028 -15.352798 -7250 2007 4 0 -4.968558 -19.050199 -15.973828 -7251 2008 6 0 -15.773463 -12.281833 -13.129558 -7252 2008 4 0 -15.686354 -12.889867 -12.384071 -7253 2008 4 0 -15.452029 -12.783419 -13.894154 -7254 2009 6 0 -4.300139 -7.123836 -2.160106 -7255 2009 4 0 -3.342814 -7.235681 -2.390788 -7256 2009 4 0 -4.824947 -7.659223 -2.750865 -7257 2010 6 0 -25.789560 20.874236 19.526065 -7258 2010 4 0 -24.843357 21.124661 19.555308 -7259 2010 4 0 -26.065421 21.149679 18.673765 -7260 2011 6 0 -9.146229 1.424908 -20.523854 -7261 2011 4 0 -10.001499 1.119683 -20.181523 -7262 2011 4 0 -8.546249 0.921170 -20.019617 -7263 2012 6 0 26.101075 5.848590 12.988450 -7264 2012 4 0 26.554693 5.084410 12.637458 -7265 2012 4 0 25.161381 5.669725 12.803554 -7266 2013 6 0 9.006687 19.040346 -18.186210 -7267 2013 4 0 8.065932 18.907108 -18.115528 -7268 2013 4 0 9.047297 19.909251 -18.666859 -7269 2014 6 0 -7.293872 14.178171 -1.883075 -7270 2014 4 0 -6.467767 14.351226 -2.386146 -7271 2014 4 0 -7.610529 15.055318 -1.621187 -7272 2015 6 0 -6.991462 19.787403 0.500962 -7273 2015 4 0 -6.438660 19.949638 1.223968 -7274 2015 4 0 -7.711116 19.103046 0.704655 -7275 2016 6 0 27.160597 -2.308726 -10.478195 -7276 2016 4 0 26.892593 -1.628933 -9.894058 -7277 2016 4 0 26.370866 -2.910166 -10.699907 -7278 2017 6 0 20.720937 15.282200 -14.602248 -7279 2017 4 0 19.787625 15.378072 -14.861312 -7280 2017 4 0 21.253153 16.033456 -14.917484 -7281 2018 6 0 -1.717777 3.126430 19.684869 -7282 2018 4 0 -2.457020 3.742545 19.704262 -7283 2018 4 0 -1.981408 2.239558 19.670325 -7284 2019 6 0 -14.236932 -8.531350 -17.888137 -7285 2019 4 0 -13.483311 -8.743594 -17.293313 -7286 2019 4 0 -14.879621 -9.247417 -17.747177 -7287 2020 6 0 -4.783415 -4.020396 -20.532866 -7288 2020 4 0 -4.012136 -4.566525 -20.414031 -7289 2020 4 0 -5.530185 -4.500179 -20.351823 -7290 2021 6 0 -13.666695 2.341198 -19.917613 -7291 2021 4 0 -13.647430 2.522072 -20.842149 -7292 2021 4 0 -14.523681 2.756089 -19.651511 -7293 2022 6 0 3.688675 -20.632144 14.338255 -7294 2022 4 0 4.124765 -20.055049 14.958708 -7295 2022 4 0 3.773276 -21.474844 14.693545 -7296 2023 6 0 -20.711810 11.153254 -5.295425 -7297 2023 4 0 -20.997628 10.543621 -4.576628 -7298 2023 4 0 -20.872806 11.978037 -4.877765 -7299 2024 6 0 24.053294 -19.987538 -18.448521 -7300 2024 4 0 23.997797 -20.379984 -19.321399 -7301 2024 4 0 24.605029 -20.616521 -17.920358 -7302 2025 6 0 18.893096 0.346665 4.419514 -7303 2025 4 0 18.836810 -0.563948 4.138422 -7304 2025 4 0 19.384494 0.416823 5.258191 -7305 2026 6 0 1.611674 7.827775 17.729516 -7306 2026 4 0 1.683155 6.883076 17.518073 -7307 2026 4 0 0.776664 7.948423 18.173512 -7308 2027 6 0 9.885872 -10.367999 -15.423519 -7309 2027 4 0 9.747228 -11.080640 -16.152068 -7310 2027 4 0 9.165955 -9.782881 -15.477159 -7311 2028 6 0 -8.001025 -8.903978 20.363588 -7312 2028 4 0 -7.919331 -9.384725 21.262606 -7313 2028 4 0 -8.555002 -9.547097 19.892421 -7314 2029 6 0 -5.444250 -12.618432 -20.512332 -7315 2029 4 0 -4.642289 -13.086364 -20.688100 -7316 2029 4 0 -5.443229 -12.055754 -19.736438 -7317 2030 6 0 13.515262 -10.012095 19.152766 -7318 2030 4 0 12.845808 -9.927516 19.858658 -7319 2030 4 0 14.340617 -9.646593 19.590648 -7320 2031 6 0 -8.356973 -7.803379 16.925718 -7321 2031 4 0 -8.140830 -7.917106 15.999678 -7322 2031 4 0 -8.084091 -8.687693 17.308394 -7323 2032 6 0 19.760910 -2.370831 2.421662 -7324 2032 4 0 20.560599 -1.857333 2.578796 -7325 2032 4 0 19.273809 -1.863655 1.723372 -7326 2033 6 0 16.532929 9.397948 -13.603509 -7327 2033 4 0 16.407542 10.353638 -13.545246 -7328 2033 4 0 17.450225 9.202690 -13.801843 -7329 2034 6 0 3.043298 -8.545676 8.964253 -7330 2034 4 0 2.418694 -7.834314 8.742863 -7331 2034 4 0 3.163757 -8.907052 8.081541 -7332 2035 6 0 -5.314921 -13.601995 0.201579 -7333 2035 4 0 -4.416708 -13.534559 -0.042940 -7334 2035 4 0 -5.417418 -14.438498 0.657175 -7335 2036 6 0 1.416185 6.843538 -11.410595 -7336 2036 4 0 1.633970 7.742217 -11.087491 -7337 2036 4 0 0.761793 6.459053 -10.786036 -7338 2037 6 0 19.767922 9.421307 -8.193013 -7339 2037 4 0 19.914480 8.466041 -8.135440 -7340 2037 4 0 19.575103 9.558308 -9.177735 -7341 2038 6 0 26.172410 11.919029 3.610739 -7342 2038 4 0 25.535585 12.193435 4.240735 -7343 2038 4 0 26.042272 10.983029 3.549151 -7344 2039 6 0 -21.735841 2.144400 18.211620 -7345 2039 4 0 -22.104009 2.960860 18.654752 -7346 2039 4 0 -22.313927 1.460249 18.492995 -7347 2040 6 0 1.557972 -12.790578 15.622137 -7348 2040 4 0 0.853719 -13.365055 15.935999 -7349 2040 4 0 1.906483 -13.231160 14.910699 -7350 2041 6 0 -13.258859 4.104211 -2.315588 -7351 2041 4 0 -13.608254 4.812418 -2.986967 -7352 2041 4 0 -14.087487 3.646024 -2.095452 -7353 2042 6 0 -26.307679 -0.111768 -20.714469 -7354 2042 4 0 -25.812995 0.720645 -20.583269 -7355 2042 4 0 -25.528348 -0.678575 -20.909717 -7356 2043 6 0 11.642962 12.398152 -6.461792 -7357 2043 4 0 11.596820 12.230702 -5.538685 -7358 2043 4 0 12.552221 12.400971 -6.683261 -7359 2044 6 0 9.805562 12.056033 0.297197 -7360 2044 4 0 10.657658 12.469311 0.654830 -7361 2044 4 0 9.202541 11.759951 0.941289 -7362 2045 6 0 -6.826832 12.393010 9.213697 -7363 2045 4 0 -6.537792 11.811004 8.506850 -7364 2045 4 0 -6.100427 12.347418 9.835231 -7365 2046 6 0 20.133141 -17.531986 18.955618 -7366 2046 4 0 19.437169 -18.073233 18.517051 -7367 2046 4 0 20.798807 -17.276415 18.236384 -7368 2047 6 0 16.549382 -10.626162 16.457286 -7369 2047 4 0 16.551942 -9.717820 16.759418 -7370 2047 4 0 16.147566 -11.023294 17.252231 -7371 2048 6 0 1.789829 14.643494 -5.619552 -7372 2048 4 0 1.048933 14.228176 -6.039228 -7373 2048 4 0 1.669053 14.391952 -4.707740 -7374 2049 6 0 4.371658 -12.694698 -12.318562 -7375 2049 4 0 4.915573 -13.184619 -11.694576 -7376 2049 4 0 4.915130 -11.958781 -12.720896 -7377 2050 6 0 -11.293082 0.237019 -19.250596 -7378 2050 4 0 -11.966255 0.783547 -19.678369 -7379 2050 4 0 -11.548510 -0.704739 -19.364586 -7380 2051 6 0 -2.484806 -0.918295 -14.668621 -7381 2051 4 0 -2.177091 -1.152345 -15.589201 -7382 2051 4 0 -1.695025 -0.610144 -14.221845 -7383 2052 6 0 25.578482 -18.001184 -14.174826 -7384 2052 4 0 24.716923 -17.519582 -14.309086 -7385 2052 4 0 26.303012 -17.438870 -14.436407 -7386 2053 6 0 23.132217 17.040870 -8.595297 -7387 2053 4 0 23.143509 17.518773 -7.762629 -7388 2053 4 0 22.923741 16.132690 -8.372110 -7389 2054 6 0 2.923503 11.871856 -20.547177 -7390 2054 4 0 2.198503 11.234695 -20.236214 -7391 2054 4 0 3.511763 11.911115 -19.844001 -7392 2055 6 0 2.179585 4.144910 -11.877852 -7393 2055 4 0 2.151655 5.096818 -11.803012 -7394 2055 4 0 2.729899 3.974673 -12.667805 -7395 2056 6 0 26.669404 -11.624549 13.477594 -7396 2056 4 0 25.735733 -11.431455 13.654851 -7397 2056 4 0 27.077849 -11.550313 14.372992 -7398 2057 6 0 24.873075 -11.097731 10.824618 -7399 2057 4 0 25.209728 -11.897467 10.432443 -7400 2057 4 0 25.614915 -10.682030 11.193580 -7401 2058 6 0 -1.826162 -17.791623 4.511609 -7402 2058 4 0 -1.466714 -17.114337 3.985489 -7403 2058 4 0 -1.066332 -18.298254 4.813832 -7404 2059 6 0 24.895806 4.512131 -17.916870 -7405 2059 4 0 24.133889 5.103597 -18.006070 -7406 2059 4 0 25.725831 4.889044 -18.163865 -7407 2060 6 0 -20.306217 1.655909 -0.658591 -7408 2060 4 0 -19.365596 1.457605 -0.837148 -7409 2060 4 0 -20.259907 1.991986 0.211928 -7410 2061 6 0 13.312009 19.524936 16.387048 -7411 2061 4 0 13.933293 19.167357 15.722455 -7412 2061 4 0 13.259660 18.816564 17.092867 -7413 2062 6 0 -6.291960 0.181353 20.409012 -7414 2062 4 0 -5.886986 -0.391564 19.697954 -7415 2062 4 0 -6.191361 -0.287042 21.246927 -7416 2063 6 0 -11.925605 -14.118393 11.513337 -7417 2063 4 0 -12.390021 -13.899494 10.677619 -7418 2063 4 0 -11.499213 -13.318961 11.825704 -7419 2064 6 0 25.690900 -20.544963 -6.726643 -7420 2064 4 0 25.848636 -19.865858 -7.443635 -7421 2064 4 0 25.541265 -21.356361 -7.237324 -7422 2065 6 0 -10.266763 4.606069 -14.148088 -7423 2065 4 0 -10.666583 4.007171 -14.802051 -7424 2065 4 0 -10.592890 5.506386 -14.316808 -7425 2066 6 0 -13.700313 11.443217 -7.703372 -7426 2066 4 0 -14.305805 11.566376 -8.451855 -7427 2066 4 0 -13.797593 10.519533 -7.520760 -7428 2067 6 0 19.896960 -5.260769 2.047938 -7429 2067 4 0 20.639909 -5.673868 2.498703 -7430 2067 4 0 19.902578 -4.275845 1.972121 -7431 2068 6 0 27.483595 4.667361 6.350280 -7432 2068 4 0 27.612327 3.821689 6.792070 -7433 2068 4 0 27.474096 5.241160 7.041075 -7434 2069 6 0 16.838162 -11.125573 -1.977415 -7435 2069 4 0 17.018636 -10.652759 -1.169733 -7436 2069 4 0 17.083147 -12.071800 -1.748280 -7437 2070 6 0 -3.825915 15.193309 16.332435 -7438 2070 4 0 -3.868970 16.088775 15.893612 -7439 2070 4 0 -2.922251 14.779372 16.138541 -7440 2071 6 0 -4.999597 -20.685905 -5.935566 -7441 2071 4 0 -5.618635 -20.401156 -6.580918 -7442 2071 4 0 -5.077868 -21.673790 -5.909799 -7443 2072 6 0 -20.562039 0.140160 5.669443 -7444 2072 4 0 -20.686050 0.843366 6.344794 -7445 2072 4 0 -20.730893 0.582485 4.804185 -7446 2073 6 0 -6.671827 11.535978 19.876374 -7447 2073 4 0 -7.261521 11.364859 20.662982 -7448 2073 4 0 -7.266511 12.144069 19.377508 -7449 2074 6 0 4.191517 -2.479488 13.355524 -7450 2074 4 0 4.884007 -2.164404 14.019008 -7451 2074 4 0 3.372874 -2.220309 13.814811 -7452 2075 6 0 8.749947 16.191041 8.535964 -7453 2075 4 0 8.732297 16.863275 9.229059 -7454 2075 4 0 8.691576 16.634682 7.644507 -7455 2076 6 0 -25.961494 14.282183 -15.383787 -7456 2076 4 0 -25.985646 15.282436 -15.164995 -7457 2076 4 0 -26.833664 13.915918 -15.151600 -7458 2077 6 0 27.385198 14.529212 8.142639 -7459 2077 4 0 26.412128 14.399556 8.083311 -7460 2077 4 0 27.495002 15.490751 8.294493 -7461 2078 6 0 14.126472 -14.702927 -8.987957 -7462 2078 4 0 14.925682 -14.560974 -8.448204 -7463 2078 4 0 13.489976 -15.067821 -8.401821 -7464 2079 6 0 -23.336636 -6.121383 -20.639900 -7465 2079 4 0 -22.869154 -5.535755 -20.072156 -7466 2079 4 0 -24.124908 -6.450781 -20.113919 -7467 2080 6 0 -0.774826 -13.203604 16.888646 -7468 2080 4 0 -1.468020 -13.376023 16.234547 -7469 2080 4 0 -0.931871 -12.304587 17.229608 -7470 2081 6 0 9.061125 5.283331 17.143683 -7471 2081 4 0 9.916783 5.174639 16.603587 -7472 2081 4 0 8.778289 6.220910 17.070877 -7473 2082 6 0 -25.315423 9.781118 -15.359265 -7474 2082 4 0 -24.471315 9.264358 -15.331486 -7475 2082 4 0 -25.606191 9.792640 -14.434801 -7476 2083 6 0 -10.967554 -10.738154 -9.731527 -7477 2083 4 0 -11.765483 -10.936834 -9.181748 -7478 2083 4 0 -10.379375 -10.133651 -9.266538 -7479 2084 6 0 -1.488275 3.623351 -16.767913 -7480 2084 4 0 -0.882657 4.371387 -16.669247 -7481 2084 4 0 -1.492403 3.254437 -17.674715 -7482 2085 6 0 12.452312 -19.040060 3.375147 -7483 2085 4 0 12.871486 -19.871899 3.246114 -7484 2085 4 0 11.754508 -18.893125 2.776534 -7485 2086 6 0 -15.573729 -12.221722 0.716973 -7486 2086 4 0 -15.002380 -12.832434 0.254063 -7487 2086 4 0 -16.254430 -12.772029 1.034977 -7488 2087 6 0 13.752256 -4.097413 -18.870896 -7489 2087 4 0 14.581949 -3.712772 -18.513163 -7490 2087 4 0 13.271688 -3.261042 -18.845949 -7491 2088 6 0 -21.641111 -0.680590 0.005430 -7492 2088 4 0 -21.093432 0.076279 -0.365044 -7493 2088 4 0 -21.445828 -0.814377 0.968664 -7494 2089 6 0 15.724559 3.520455 6.328412 -7495 2089 4 0 14.921141 3.234676 6.784467 -7496 2089 4 0 15.461693 3.698167 5.450324 -7497 2090 6 0 -27.214078 -11.147965 5.082767 -7498 2090 4 0 -26.390239 -11.278816 5.572480 -7499 2090 4 0 -27.321203 -12.054005 4.683669 -7500 2091 6 0 13.328280 7.582484 -18.567300 -7501 2091 4 0 14.185844 7.864153 -18.950423 -7502 2091 4 0 12.732777 7.507446 -19.290185 -7503 2092 6 0 -16.683838 -4.586561 -13.916725 -7504 2092 4 0 -16.820834 -4.523796 -14.842726 -7505 2092 4 0 -15.965498 -5.193692 -13.685180 -7506 2093 6 0 -19.170260 12.551147 12.092952 -7507 2093 4 0 -19.387562 11.609567 12.048568 -7508 2093 4 0 -18.718827 12.726237 11.286473 -7509 2094 6 0 -2.873940 -18.817391 -0.630738 -7510 2094 4 0 -2.585106 -18.870724 -1.613607 -7511 2094 4 0 -3.793192 -19.000736 -0.761036 -7512 2095 6 0 -15.440453 11.669180 16.607856 -7513 2095 4 0 -15.211613 10.749409 16.748182 -7514 2095 4 0 -15.523689 11.929189 17.511524 -7515 2096 6 0 0.676885 9.019049 7.967361 -7516 2096 4 0 -0.188437 8.924038 8.296825 -7517 2096 4 0 1.100577 8.314509 8.389075 -7518 2097 6 0 -12.658914 -13.169855 -2.443871 -7519 2097 4 0 -13.329719 -13.325087 -1.824892 -7520 2097 4 0 -12.438077 -13.988972 -2.754186 -7521 2098 6 0 -16.248882 -11.627131 16.273828 -7522 2098 4 0 -16.071661 -12.035171 17.149648 -7523 2098 4 0 -15.584055 -10.905357 16.247158 -7524 2099 6 0 7.587639 18.040490 0.648325 -7525 2099 4 0 7.127313 17.621736 1.427370 -7526 2099 4 0 8.472509 18.025945 0.938181 -7527 2100 6 0 -21.260403 -7.316165 -17.769548 -7528 2100 4 0 -21.464936 -6.579095 -18.356837 -7529 2100 4 0 -21.090642 -6.945093 -16.896335 -7530 2101 6 0 16.016635 -1.860641 -2.314369 -7531 2101 4 0 16.938184 -1.677711 -2.476393 -7532 2101 4 0 15.526197 -1.857629 -3.158683 -7533 2102 6 0 4.492292 -4.776655 -20.071507 -7534 2102 4 0 4.666835 -4.194018 -19.383577 -7535 2102 4 0 5.379154 -5.033244 -20.511472 -7536 2103 6 0 -15.720931 20.128785 -10.578428 -7537 2103 4 0 -15.839702 20.941641 -10.100642 -7538 2103 4 0 -16.315376 20.178519 -11.349297 -7539 2104 6 0 -26.439198 6.163682 -9.860618 -7540 2104 4 0 -25.627768 6.495816 -9.484731 -7541 2104 4 0 -26.911803 6.981208 -10.036013 -7542 2105 6 0 9.335945 11.329795 -3.722917 -7543 2105 4 0 8.644451 12.059424 -3.617751 -7544 2105 4 0 8.888513 10.554570 -4.126032 -7545 2106 6 0 -13.380471 10.478242 6.861111 -7546 2106 4 0 -13.220641 10.103750 7.786550 -7547 2106 4 0 -13.207886 11.438191 6.902907 -7548 2107 6 0 3.128674 -13.794262 17.620598 -7549 2107 4 0 2.638158 -13.260660 17.056399 -7550 2107 4 0 3.597573 -13.167888 18.155001 -7551 2108 6 0 -15.640110 12.239687 19.252890 -7552 2108 4 0 -15.744305 13.228589 19.346365 -7553 2108 4 0 -16.382496 11.838747 19.767704 -7554 2109 6 0 2.784908 9.116859 -10.197973 -7555 2109 4 0 3.297798 8.414513 -9.705521 -7556 2109 4 0 3.275248 9.528201 -10.883691 -7557 2110 6 0 -7.890712 -7.603783 -17.743202 -7558 2110 4 0 -7.124761 -7.008882 -17.935759 -7559 2110 4 0 -8.550851 -7.045750 -18.114982 -7560 2111 6 0 -13.699956 -6.291585 9.543158 -7561 2111 4 0 -14.665087 -6.196216 9.729838 -7562 2111 4 0 -13.399326 -5.367978 9.707420 -7563 2112 6 0 20.465588 -10.458716 3.145054 -7564 2112 4 0 20.979944 -10.701349 3.922596 -7565 2112 4 0 19.551694 -10.315318 3.519540 -7566 2113 6 0 -21.770772 17.965042 -17.112890 -7567 2113 4 0 -20.830189 18.026694 -16.817043 -7568 2113 4 0 -22.065602 18.901599 -17.079860 -7569 2114 6 0 -14.835473 -2.018047 -6.153382 -7570 2114 4 0 -15.436027 -2.198495 -6.881730 -7571 2114 4 0 -15.436197 -1.848312 -5.360006 -7572 2115 6 0 4.864928 -7.193456 16.503727 -7573 2115 4 0 4.980211 -6.246101 16.323915 -7574 2115 4 0 5.579734 -7.640000 16.024530 -7575 2116 6 0 19.120349 11.030815 -15.362470 -7576 2116 4 0 19.294800 10.826080 -16.279672 -7577 2116 4 0 19.622213 10.380633 -14.881548 -7578 2117 6 0 -0.977018 13.926628 -7.123442 -7579 2117 4 0 -1.852314 14.048847 -6.757564 -7580 2117 4 0 -1.008005 14.146864 -8.050474 -7581 2118 6 0 1.836955 20.649010 5.205237 -7582 2118 4 0 1.357046 19.856623 4.900209 -7583 2118 4 0 2.481382 20.946625 4.486330 -7584 2119 6 0 22.248352 0.089789 14.254305 -7585 2119 4 0 21.482126 0.622149 14.431275 -7586 2119 4 0 22.760633 -0.073685 15.065722 -7587 2120 6 0 4.943704 7.039238 -17.178880 -7588 2120 4 0 4.132510 7.341202 -17.610714 -7589 2120 4 0 5.316936 6.264192 -17.636046 -7590 2121 6 0 -13.513178 20.872697 -6.966661 -7591 2121 4 0 -12.917889 20.159554 -6.816410 -7592 2121 4 0 -13.438901 21.399519 -6.129707 -7593 2122 6 0 -26.783745 1.737872 -10.173855 -7594 2122 4 0 -27.406703 1.045834 -9.889439 -7595 2122 4 0 -26.563015 2.284868 -9.419251 -7596 2123 6 0 16.895897 -14.537239 -4.916419 -7597 2123 4 0 17.186118 -13.833540 -5.508216 -7598 2123 4 0 17.149098 -15.342322 -5.413605 -7599 2124 6 0 26.817205 -3.814990 8.332532 -7600 2124 4 0 26.423093 -3.721401 9.229654 -7601 2124 4 0 26.751966 -4.740274 8.261936 -7602 2125 6 0 26.660512 -8.107918 -18.699113 -7603 2125 4 0 27.143708 -8.664547 -19.302869 -7604 2125 4 0 27.318084 -7.817236 -18.086633 -7605 2126 6 0 10.208858 -14.799716 -11.685147 -7606 2126 4 0 10.229559 -13.857528 -11.605014 -7607 2126 4 0 10.909011 -14.996510 -12.361468 -7608 2127 6 0 -7.122161 12.606835 5.012358 -7609 2127 4 0 -6.742894 13.446553 5.343573 -7610 2127 4 0 -6.707272 11.958739 5.582727 -7611 2128 6 0 -1.649859 -17.353593 -19.765333 -7612 2128 4 0 -1.703196 -17.292489 -18.801764 -7613 2128 4 0 -0.740888 -17.269565 -19.956034 -7614 2129 6 0 -25.578511 10.750973 19.368175 -7615 2129 4 0 -25.759953 9.955006 18.909465 -7616 2129 4 0 -26.373616 10.876703 19.816004 -7617 2130 6 0 -15.512850 14.948587 19.552015 -7618 2130 4 0 -14.592416 15.278921 19.862734 -7619 2130 4 0 -15.517720 15.251241 18.670365 -7620 2131 6 0 -22.108713 15.986768 -19.097538 -7621 2131 4 0 -21.973356 16.492171 -18.298729 -7622 2131 4 0 -22.275608 15.084558 -18.884443 -7623 2132 6 0 -24.432040 1.967038 -20.402572 -7624 2132 4 0 -24.316057 2.005234 -19.442897 -7625 2132 4 0 -23.617246 1.596664 -20.796357 -7626 2133 6 0 0.976021 12.002153 3.317883 -7627 2133 4 0 1.233810 12.944966 3.271665 -7628 2133 4 0 1.053167 11.659322 4.215764 -7629 2134 6 0 -22.848328 -11.507211 20.792792 -7630 2134 4 0 -22.031691 -11.288244 20.331458 -7631 2134 4 0 -23.563342 -11.121670 20.237130 -7632 2135 6 0 5.372331 -6.390447 8.998397 -7633 2135 4 0 5.156327 -6.136745 8.105017 -7634 2135 4 0 4.867716 -7.183706 9.243399 -7635 2136 6 0 -5.077546 13.038740 -9.712665 -7636 2136 4 0 -4.384730 12.918197 -10.436683 -7637 2136 4 0 -5.739596 12.361322 -9.833579 -7638 2137 6 0 4.313864 -17.817036 1.578679 -7639 2137 4 0 3.642179 -17.175797 1.786403 -7640 2137 4 0 4.014882 -18.443226 0.872394 -7641 2138 6 0 -10.825600 -3.788470 12.345548 -7642 2138 4 0 -11.474785 -4.350281 12.848087 -7643 2138 4 0 -11.121245 -2.913918 12.572141 -7644 2139 6 0 -10.308333 17.332588 -19.108687 -7645 2139 4 0 -9.699779 18.058376 -18.760246 -7646 2139 4 0 -9.696827 16.600840 -19.450737 -7647 2140 6 0 20.367843 11.704165 19.663819 -7648 2140 4 0 19.894726 12.360595 20.126357 -7649 2140 4 0 20.501092 12.010854 18.743343 -7650 2141 6 0 4.454769 15.397642 -5.721382 -7651 2141 4 0 5.096605 14.668068 -5.812036 -7652 2141 4 0 3.560506 15.012254 -5.700523 -7653 2142 6 0 -10.186828 -2.388640 -11.736429 -7654 2142 4 0 -10.325119 -2.558008 -12.705589 -7655 2142 4 0 -10.806607 -2.883931 -11.193573 -7656 2143 6 0 -24.912356 3.520925 11.318625 -7657 2143 4 0 -24.410292 4.337248 11.078911 -7658 2143 4 0 -25.009199 2.856626 10.581227 -7659 2144 6 0 25.624082 -17.044203 16.133293 -7660 2144 4 0 26.569447 -17.105418 15.881796 -7661 2144 4 0 25.526730 -16.778186 17.038064 -7662 2145 6 0 -18.172292 -12.061346 20.656118 -7663 2145 4 0 -19.064000 -11.714052 20.415716 -7664 2145 4 0 -18.318393 -12.531580 21.542312 -7665 2146 6 0 -2.771360 17.065768 -3.605776 -7666 2146 4 0 -3.498372 16.467521 -3.261648 -7667 2146 4 0 -3.165333 17.613939 -4.263088 -7668 2147 6 0 3.828793 -18.285133 -12.035298 -7669 2147 4 0 4.572657 -18.613626 -12.559285 -7670 2147 4 0 4.121067 -17.462806 -11.547371 -7671 2148 6 0 6.372209 19.895468 -0.828574 -7672 2148 4 0 6.671245 19.260688 -0.181419 -7673 2148 4 0 6.498252 20.741942 -0.410853 -7674 2149 6 0 -26.077165 -2.986273 -6.579517 -7675 2149 4 0 -26.530567 -3.662357 -7.045915 -7676 2149 4 0 -25.278966 -3.412687 -6.199533 -7677 2150 6 0 1.066751 -11.604098 -7.437054 -7678 2150 4 0 0.780778 -12.103600 -8.170135 -7679 2150 4 0 0.490797 -10.859423 -7.390052 -7680 2151 6 0 26.435886 -19.880105 20.436273 -7681 2151 4 0 27.363986 -19.578464 20.393790 -7682 2151 4 0 25.964716 -19.053915 20.333618 -7683 2152 6 0 3.948373 18.634138 -19.227666 -7684 2152 4 0 4.776804 18.681442 -18.670875 -7685 2152 4 0 3.724437 19.545742 -19.268399 -7686 2153 6 0 6.895853 -2.593776 -14.926776 -7687 2153 4 0 6.939228 -1.872325 -14.297950 -7688 2153 4 0 5.922138 -2.668665 -14.881269 -7689 2154 6 0 -11.002838 -0.157918 -15.377800 -7690 2154 4 0 -11.039095 0.271800 -14.533222 -7691 2154 4 0 -11.858546 -0.101002 -15.791180 -7692 2155 6 0 -23.278682 -12.335400 16.986956 -7693 2155 4 0 -23.969958 -13.046960 17.013455 -7694 2155 4 0 -23.739191 -11.494386 17.223424 -7695 2156 6 0 -8.733901 10.961189 15.538536 -7696 2156 4 0 -9.664866 10.721280 15.448379 -7697 2156 4 0 -8.333145 10.082375 15.772687 -7698 2157 6 0 -18.407350 15.043497 -16.093194 -7699 2157 4 0 -17.602548 15.511802 -15.718946 -7700 2157 4 0 -18.860502 14.688871 -15.320254 -7701 2158 6 0 -7.717846 -19.245322 6.135762 -7702 2158 4 0 -8.369623 -18.587554 5.773934 -7703 2158 4 0 -8.005786 -19.439467 7.014406 -7704 2159 6 0 27.537835 -2.244938 17.802365 -7705 2159 4 0 26.595262 -2.186775 17.618048 -7706 2159 4 0 27.566413 -2.809518 18.555718 -7707 2160 6 0 14.035672 -13.942494 -5.025234 -7708 2160 4 0 13.436663 -14.726681 -5.087496 -7709 2160 4 0 14.937241 -14.361386 -5.014306 -7710 2161 6 0 -21.221588 13.030355 13.864922 -7711 2161 4 0 -20.364838 12.937985 13.362956 -7712 2161 4 0 -21.556169 12.132892 13.747752 -7713 2162 6 0 3.382602 17.477038 1.971338 -7714 2162 4 0 2.998725 16.711070 1.403757 -7715 2162 4 0 3.440438 18.202483 1.331855 -7716 2163 6 0 -27.449290 2.763472 -5.473864 -7717 2163 4 0 -26.862644 2.952928 -6.231930 -7718 2163 4 0 -28.220354 2.416823 -5.903707 -7719 2164 6 0 21.309171 1.208177 18.719816 -7720 2164 4 0 20.908787 2.039246 18.612886 -7721 2164 4 0 21.184556 0.863131 19.641302 -7722 2165 6 0 11.888692 16.675087 -12.603821 -7723 2165 4 0 10.999248 16.541633 -13.021832 -7724 2165 4 0 11.878107 16.199062 -11.723643 -7725 2166 6 0 15.960563 -12.459489 -12.277920 -7726 2166 4 0 16.878686 -12.644050 -12.500987 -7727 2166 4 0 16.057647 -11.602612 -11.757235 -7728 2167 6 0 -12.060427 7.034589 4.513332 -7729 2167 4 0 -11.557894 7.520852 3.823017 -7730 2167 4 0 -11.343768 6.740188 5.138402 -7731 2168 6 0 -8.561873 -15.574827 18.511819 -7732 2168 4 0 -8.355748 -14.726119 18.975068 -7733 2168 4 0 -9.321577 -15.327632 17.928691 -7734 2169 6 0 26.839386 -9.977418 -11.801214 -7735 2169 4 0 27.210714 -10.886833 -12.066458 -7736 2169 4 0 26.680237 -9.508287 -12.672668 -7737 2170 6 0 19.487816 -4.295750 -10.653772 -7738 2170 4 0 19.155987 -5.040203 -11.186489 -7739 2170 4 0 19.101905 -4.274245 -9.721574 -7740 2171 6 0 -2.617367 -9.196096 12.807798 -7741 2171 4 0 -3.053330 -8.849761 12.003083 -7742 2171 4 0 -1.757135 -8.732443 12.734709 -7743 2172 6 0 6.741614 9.283527 -17.879312 -7744 2172 4 0 6.380288 9.612761 -18.710343 -7745 2172 4 0 6.169408 8.510946 -17.615438 -7746 2173 6 0 -15.244518 -2.348788 -16.411194 -7747 2173 4 0 -15.286492 -3.293206 -16.627416 -7748 2173 4 0 -16.141604 -2.133344 -16.101761 -7749 2174 6 0 24.076224 14.005333 -20.764432 -7750 2174 4 0 23.579840 13.567519 -20.086274 -7751 2174 4 0 24.304722 13.264661 -21.387917 -7752 2175 6 0 5.197586 -0.122428 -17.048391 -7753 2175 4 0 5.961074 0.070496 -16.498322 -7754 2175 4 0 4.803638 0.707910 -17.262899 -7755 2176 6 0 -12.626531 20.869184 -20.635254 -7756 2176 4 0 -12.565754 20.478495 -19.764243 -7757 2176 4 0 -13.248230 21.560435 -20.592028 -7758 2177 6 0 -6.742302 15.365874 -8.317692 -7759 2177 4 0 -6.373557 14.699314 -8.910768 -7760 2177 4 0 -7.355781 15.918239 -8.809096 -7761 2178 6 0 -8.968953 -3.618531 16.586721 -7762 2178 4 0 -8.318587 -4.203738 17.052583 -7763 2178 4 0 -8.772937 -2.703569 16.930654 -7764 2179 6 0 4.646490 -13.425952 -20.543948 -7765 2179 4 0 5.006101 -13.053008 -19.771175 -7766 2179 4 0 4.114028 -14.244399 -20.306406 -7767 2180 6 0 20.560148 15.165785 18.388964 -7768 2180 4 0 20.026901 15.914780 18.133927 -7769 2180 4 0 20.137478 14.695974 19.131845 -7770 2181 6 0 16.253616 13.647989 17.466410 -7771 2181 4 0 16.144396 14.607506 17.611846 -7772 2181 4 0 15.603177 13.394335 16.728326 -7773 2182 6 0 -2.493112 -10.958918 18.158226 -7774 2182 4 0 -2.871350 -10.325469 17.572446 -7775 2182 4 0 -3.230138 -11.343072 18.670608 -7776 2183 6 0 24.417011 1.731847 15.781773 -7777 2183 4 0 24.256339 1.199810 16.598463 -7778 2183 4 0 24.103762 2.612690 16.033534 -7779 2184 6 0 23.869641 5.093835 -10.829152 -7780 2184 4 0 23.849127 5.899360 -10.350720 -7781 2184 4 0 24.806312 4.827153 -11.005653 -7782 2185 6 0 -25.326011 -10.985445 0.393748 -7783 2185 4 0 -24.487021 -11.323998 0.018652 -7784 2185 4 0 -25.846018 -10.577330 -0.299092 -7785 2186 6 0 -22.140365 -4.015548 -19.394205 -7786 2186 4 0 -21.298001 -3.731962 -19.753685 -7787 2186 4 0 -22.037014 -3.787820 -18.464135 -7788 2187 6 0 16.480100 17.378886 -8.149325 -7789 2187 4 0 15.944629 17.865308 -8.816984 -7790 2187 4 0 17.136048 16.933781 -8.707099 -7791 2188 6 0 9.225758 13.395457 -14.366037 -7792 2188 4 0 8.369757 13.485099 -14.794251 -7793 2188 4 0 9.149310 12.977217 -13.491919 -7794 2189 6 0 -11.512364 7.735604 17.233390 -7795 2189 4 0 -11.580776 7.745448 18.221759 -7796 2189 4 0 -10.572713 7.856344 17.057877 -7797 2190 6 0 22.313965 -17.567699 -18.743216 -7798 2190 4 0 22.795472 -18.390700 -18.665650 -7799 2190 4 0 21.527641 -17.771604 -19.283408 -7800 2191 6 0 26.008630 -8.991349 -9.190478 -7801 2191 4 0 26.251546 -9.200527 -10.105321 -7802 2191 4 0 25.207812 -9.493737 -9.000776 -7803 2192 6 0 16.930474 19.046264 7.447647 -7804 2192 4 0 16.385483 19.298108 8.210284 -7805 2192 4 0 17.081495 19.851182 6.876771 -7806 2193 6 0 -6.878192 14.458044 -14.342832 -7807 2193 4 0 -6.947724 15.178650 -14.986529 -7808 2193 4 0 -6.902494 14.876539 -13.459345 -7809 2194 6 0 -2.603745 -0.170130 11.118461 -7810 2194 4 0 -2.603735 0.193993 10.245898 -7811 2194 4 0 -2.301286 0.557857 11.700540 -7812 2195 6 0 -18.658918 6.935889 12.709416 -7813 2195 4 0 -18.611105 7.903442 12.826990 -7814 2195 4 0 -17.731206 6.682204 12.672567 -7815 2196 6 0 8.242150 20.321564 16.671943 -7816 2196 4 0 8.085884 19.395160 16.403784 -7817 2196 4 0 9.204603 20.443804 16.719883 -7818 2197 6 0 -26.194647 -1.598660 12.827976 -7819 2197 4 0 -25.470850 -1.539447 12.228660 -7820 2197 4 0 -26.434617 -2.532329 12.905279 -7821 2198 6 0 18.147255 11.834318 16.939503 -7822 2198 4 0 17.684791 12.638752 17.229443 -7823 2198 4 0 19.094703 11.992223 16.922098 -7824 2199 6 0 -24.103113 17.414200 -20.406032 -7825 2199 4 0 -24.841847 16.822155 -20.721607 -7826 2199 4 0 -23.364705 16.873068 -20.183752 -7827 2200 6 0 -20.188758 19.419367 -3.947439 -7828 2200 4 0 -20.092108 20.138589 -4.627770 -7829 2200 4 0 -20.779520 18.760391 -4.305720 -7830 2201 6 0 -19.169152 16.892293 -12.706791 -7831 2201 4 0 -18.376967 16.525250 -12.263419 -7832 2201 4 0 -19.451828 16.244073 -13.317784 -7833 2202 6 0 3.042793 -9.624584 6.339287 -7834 2202 4 0 2.126469 -9.764000 6.059404 -7835 2202 4 0 3.422607 -10.448883 6.082030 -7836 2203 6 0 26.796575 -0.250362 10.146355 -7837 2203 4 0 27.695465 -0.487351 9.790163 -7838 2203 4 0 26.991766 0.015930 11.058370 -7839 2204 6 0 -2.724018 -17.347993 -17.041468 -7840 2204 4 0 -3.685391 -17.148462 -17.004347 -7841 2204 4 0 -2.333214 -17.040061 -16.217705 -7842 2205 6 0 22.693834 -19.258880 -8.334918 -7843 2205 4 0 23.207274 -18.747223 -7.672504 -7844 2205 4 0 21.922700 -19.482635 -7.787257 -7845 2206 6 0 10.650819 14.245326 -8.863815 -7846 2206 4 0 10.590380 14.958254 -9.492462 -7847 2206 4 0 9.797431 14.052470 -8.521894 -7848 2207 6 0 21.896317 10.846424 11.520743 -7849 2207 4 0 22.820423 10.614982 11.723752 -7850 2207 4 0 21.512259 10.848333 12.397036 -7851 2208 6 0 -16.629808 6.024934 -16.061930 -7852 2208 4 0 -16.979035 6.163556 -15.154311 -7853 2208 4 0 -16.556800 6.853702 -16.565081 -7854 2209 6 0 -24.056464 -15.267357 -3.334116 -7855 2209 4 0 -24.017471 -15.426759 -2.411717 -7856 2209 4 0 -23.826595 -16.112409 -3.791556 -7857 2210 6 0 -24.814205 14.617559 -6.421721 -7858 2210 4 0 -24.613019 15.462145 -6.916680 -7859 2210 4 0 -25.784459 14.689331 -6.455648 -7860 2211 6 0 12.539335 -4.690091 16.952299 -7861 2211 4 0 12.874872 -3.959104 17.433778 -7862 2211 4 0 13.165313 -5.396450 16.984519 -7863 2212 6 0 27.426473 -20.349285 -4.187459 -7864 2212 4 0 26.932613 -20.185019 -4.988935 -7865 2212 4 0 27.020619 -19.915963 -3.444392 -7866 2213 6 0 -25.378069 18.390923 12.676602 -7867 2213 4 0 -25.468295 18.108442 13.617931 -7868 2213 4 0 -26.284264 18.454249 12.373374 -7869 2214 6 0 2.358488 15.655904 0.172343 -7870 2214 4 0 1.576275 15.538047 -0.330180 -7871 2214 4 0 2.949284 15.115348 -0.279388 -7872 2215 6 0 17.823860 -16.181961 4.219054 -7873 2215 4 0 16.871832 -16.285669 3.895196 -7874 2215 4 0 18.296855 -16.171292 3.367102 -7875 2216 6 0 -13.185175 11.185524 20.273552 -7876 2216 4 0 -12.491020 11.326572 19.606343 -7877 2216 4 0 -14.008783 11.327741 19.799749 -7878 2217 6 0 -16.946375 18.382248 -17.880917 -7879 2217 4 0 -16.601871 19.114714 -17.373712 -7880 2217 4 0 -17.112525 18.719683 -18.756566 -7881 2218 6 0 4.139489 13.924517 -8.158999 -7882 2218 4 0 3.276763 13.674016 -7.871220 -7883 2218 4 0 4.619548 13.009700 -8.222873 -7884 2219 6 0 19.195530 19.194186 -15.410073 -7885 2219 4 0 19.530087 20.044690 -15.698710 -7886 2219 4 0 18.880211 18.717599 -16.173654 -7887 2220 6 0 22.465366 -15.697985 -16.572314 -7888 2220 4 0 22.341005 -16.447983 -17.175221 -7889 2220 4 0 23.268415 -15.298896 -16.787665 -7890 2221 6 0 -6.168779 -9.840021 -9.350190 -7891 2221 4 0 -6.138060 -10.776075 -9.519650 -7892 2221 4 0 -5.375773 -9.424169 -9.650695 -7893 2222 6 0 25.209173 18.017697 -14.898072 -7894 2222 4 0 24.521605 17.467415 -14.490123 -7895 2222 4 0 25.669461 17.420196 -15.513375 -7896 2223 6 0 1.750289 -0.354167 -16.972701 -7897 2223 4 0 1.941430 -1.107141 -17.603779 -7898 2223 4 0 1.332140 0.330238 -17.528621 -7899 2224 6 0 18.682749 11.765475 10.852294 -7900 2224 4 0 19.563556 11.904202 10.494828 -7901 2224 4 0 18.677947 10.845188 11.223074 -7902 2225 6 0 -9.368425 16.562190 4.853452 -7903 2225 4 0 -8.407375 16.292116 4.842479 -7904 2225 4 0 -9.332928 17.502581 4.563723 -7905 2226 6 0 -14.320728 -5.516222 -17.892457 -7906 2226 4 0 -14.106677 -5.147397 -18.800379 -7907 2226 4 0 -14.225038 -6.471192 -17.943054 -7908 2227 6 0 -22.779663 -5.587037 4.961004 -7909 2227 4 0 -23.387774 -5.905882 4.279957 -7910 2227 4 0 -22.003636 -6.116854 4.731429 -7911 2228 6 0 1.608693 14.675487 10.806060 -7912 2228 4 0 2.333564 15.322059 10.910925 -7913 2228 4 0 1.191042 14.647480 11.723121 -7914 2229 6 0 -19.989851 14.272748 -13.831000 -7915 2229 4 0 -20.108765 14.145345 -12.856725 -7916 2229 4 0 -20.810178 14.265544 -14.251075 -7917 2230 6 0 -0.277500 6.116052 -20.054497 -7918 2230 4 0 -1.205482 6.025573 -19.750342 -7919 2230 4 0 0.030270 6.890733 -19.590961 -7920 2231 6 0 -23.218686 16.925049 -14.531729 -7921 2231 4 0 -24.154801 17.137589 -14.620012 -7922 2231 4 0 -22.798436 17.177619 -15.342960 -7923 2232 6 0 14.465041 -13.890297 11.092988 -7924 2232 4 0 14.125737 -13.087596 11.450092 -7925 2232 4 0 14.769204 -13.729760 10.198115 -7926 2233 6 0 -19.342535 19.484499 18.315509 -7927 2233 4 0 -18.817282 19.354539 19.111327 -7928 2233 4 0 -19.942353 18.726732 18.320837 -7929 2234 6 0 0.909574 12.732606 15.451247 -7930 2234 4 0 0.713888 11.749814 15.284439 -7931 2234 4 0 1.425345 12.740199 16.283139 -7932 2235 6 0 -2.274926 14.829696 20.985211 -7933 2235 4 0 -2.781123 13.962453 20.790809 -7934 2235 4 0 -2.630126 15.421882 20.359114 -7935 2236 6 0 7.507399 6.793027 13.609399 -7936 2236 4 0 7.518937 7.728154 13.813229 -7937 2236 4 0 8.443553 6.424691 13.587889 -7938 2237 6 0 12.870660 -12.764019 -10.964166 -7939 2237 4 0 12.942835 -13.465015 -11.598871 -7940 2237 4 0 13.227628 -13.197338 -10.244586 -7941 2238 6 0 8.913179 -11.919018 -6.239675 -7942 2238 4 0 8.887002 -11.850316 -5.252925 -7943 2238 4 0 8.813455 -11.004941 -6.499380 -7944 2239 6 0 -25.746417 7.206326 5.578919 -7945 2239 4 0 -25.082293 6.620904 5.823246 -7946 2239 4 0 -26.564541 6.922453 6.051858 -7947 2240 6 0 25.894755 9.257899 3.861774 -7948 2240 4 0 26.648604 8.789353 3.465470 -7949 2240 4 0 25.145952 8.756940 3.475241 -7950 2241 6 0 -8.830905 19.535286 -18.058852 -7951 2241 4 0 -7.932809 19.419232 -17.567730 -7952 2241 4 0 -8.446850 19.854198 -18.903385 -7953 2242 6 0 18.592621 -6.587479 -13.125998 -7954 2242 4 0 18.627063 -5.766281 -13.617980 -7955 2242 4 0 19.549944 -6.934441 -13.170231 -7956 2243 6 0 -27.003747 -19.268722 -9.708049 -7957 2243 4 0 -26.900925 -18.931745 -10.609127 -7958 2243 4 0 -27.848600 -18.948692 -9.403186 -7959 2244 6 0 25.990256 18.432601 -19.230300 -7960 2244 4 0 26.786890 18.827306 -19.540837 -7961 2244 4 0 25.720829 18.921009 -18.426769 -7962 2245 6 0 -23.820277 -18.817979 -12.740742 -7963 2245 4 0 -23.782285 -19.769046 -12.956748 -7964 2245 4 0 -23.248364 -18.334977 -13.329239 -7965 2246 6 0 -18.359691 4.931419 0.480080 -7966 2246 4 0 -18.326292 5.822977 0.895967 -7967 2246 4 0 -17.534355 4.919940 -0.130658 -7968 2247 6 0 -18.507249 20.994985 10.044481 -7969 2247 4 0 -18.547987 20.135365 9.607738 -7970 2247 4 0 -19.101082 20.989892 10.808237 -7971 2248 6 0 -4.383167 -16.727404 18.388451 -7972 2248 4 0 -5.073507 -17.158665 17.848255 -7973 2248 4 0 -3.547429 -16.962110 18.031186 -7974 2249 6 0 -4.804252 -2.255440 12.424858 -7975 2249 4 0 -5.246469 -3.100345 12.658891 -7976 2249 4 0 -3.913941 -2.453866 12.205563 -7977 2250 6 0 -24.450781 12.411164 4.813077 -7978 2250 4 0 -24.979534 11.582140 4.901976 -7979 2250 4 0 -24.028938 12.289668 3.990280 -7980 2251 6 0 -26.039273 15.478503 -20.033643 -7981 2251 4 0 -25.787380 14.593225 -19.599455 -7982 2251 4 0 -26.775794 15.819420 -19.491089 -7983 2252 6 0 14.062056 9.563642 16.993740 -7984 2252 4 0 14.763770 8.911350 17.143673 -7985 2252 4 0 14.500104 10.412012 17.077299 -7986 2253 6 0 4.484184 -11.730676 11.850201 -7987 2253 4 0 4.881439 -12.103947 12.684819 -7988 2253 4 0 3.547835 -11.668873 12.049225 -7989 2254 6 0 -14.097503 8.062860 -18.256877 -7990 2254 4 0 -14.097091 8.286015 -19.217701 -7991 2254 4 0 -14.272348 7.101844 -18.168430 -7992 2255 6 0 -1.242617 -6.859800 16.709128 -7993 2255 4 0 -1.538903 -6.069642 17.158826 -7994 2255 4 0 -0.956774 -6.520222 15.820973 -7995 2256 6 0 -1.281101 10.186382 20.363478 -7996 2256 4 0 -1.124991 9.953584 19.434999 -7997 2256 4 0 -1.916024 10.917360 20.415283 -7998 2257 6 0 4.583247 -14.837260 7.792526 -7999 2257 4 0 5.277242 -15.516956 7.802532 -8000 2257 4 0 3.716772 -15.158571 7.921129 -8001 2258 6 0 -4.482585 -19.369183 -19.767924 -8002 2258 4 0 -4.741173 -18.669761 -19.147665 -8003 2258 4 0 -4.193943 -19.053555 -20.619737 -8004 2259 6 0 7.047318 -14.707276 -20.284385 -8005 2259 4 0 6.703500 -15.207330 -19.488017 -8006 2259 4 0 6.190142 -14.503563 -20.700524 -8007 2260 6 0 23.833142 -6.861157 16.589067 -8008 2260 4 0 24.695476 -7.170817 16.950692 -8009 2260 4 0 23.677150 -7.301955 15.784807 -8010 2261 6 0 5.995679 -17.998909 3.914141 -8011 2261 4 0 5.476318 -17.882781 3.080567 -8012 2261 4 0 5.412579 -18.346872 4.640099 -8013 2262 6 0 -16.261535 -16.837503 19.128385 -8014 2262 4 0 -16.159495 -17.582113 18.531735 -8015 2262 4 0 -16.037295 -17.072210 20.047591 -8016 2263 6 0 12.975391 18.290335 10.617581 -8017 2263 4 0 12.118949 18.283115 10.175431 -8018 2263 4 0 12.802601 18.580055 11.511186 -8019 2264 6 0 -16.943334 -0.673380 -20.801827 -8020 2264 4 0 -17.817924 -1.087446 -20.715945 -8021 2264 4 0 -17.115465 0.133442 -21.270654 -8022 2265 6 0 6.976699 -19.049773 17.844693 -8023 2265 4 0 7.570702 -18.339339 17.660197 -8024 2265 4 0 7.315559 -19.860252 17.427987 -8025 2266 6 0 24.109467 19.393222 12.331621 -8026 2266 4 0 23.874527 19.733950 13.195341 -8027 2266 4 0 23.847585 18.486492 12.389872 -8028 2267 6 0 -10.766788 -13.469242 4.827464 -8029 2267 4 0 -10.709694 -13.795601 3.910452 -8030 2267 4 0 -10.845380 -12.510608 4.689270 -8031 2268 6 0 23.311349 8.299149 -20.488106 -8032 2268 4 0 22.936005 9.229209 -20.435353 -8033 2268 4 0 23.101181 8.056904 -21.396526 -8034 2269 6 0 14.346382 2.187727 18.536242 -8035 2269 4 0 14.267850 1.244178 18.689768 -8036 2269 4 0 15.244469 2.406046 18.304739 -8037 2270 6 0 -26.947566 -9.971921 -7.791553 -8038 2270 4 0 -26.523003 -9.588995 -7.018587 -8039 2270 4 0 -27.719947 -9.398867 -7.926452 -8040 2271 6 0 -1.645004 -17.217466 18.281848 -8041 2271 4 0 -1.503441 -17.212547 17.328466 -8042 2271 4 0 -1.259441 -16.407871 18.526419 -8043 2272 6 0 -18.185068 -13.481465 -18.963605 -8044 2272 4 0 -18.306998 -12.962840 -18.154768 -8045 2272 4 0 -18.826126 -14.192063 -18.983318 -8046 2273 6 0 21.894032 -11.323972 -14.426640 -8047 2273 4 0 22.165764 -10.897898 -13.607124 -8048 2273 4 0 22.549926 -11.213429 -15.092175 -8049 2274 6 0 10.286552 3.282899 -14.672865 -8050 2274 4 0 10.156644 2.736482 -13.881860 -8051 2274 4 0 9.503828 3.794923 -14.925645 -8052 2275 6 0 -17.275465 -16.899995 -12.204316 -8053 2275 4 0 -16.650047 -17.347498 -12.847925 -8054 2275 4 0 -17.728716 -17.694142 -11.839955 -8055 2276 6 0 9.132713 -17.465568 14.475104 -8056 2276 4 0 9.109121 -16.931937 13.716053 -8057 2276 4 0 8.685477 -18.260615 14.298118 -8058 2277 6 0 -2.219003 -10.437316 7.385585 -8059 2277 4 0 -2.683869 -9.726981 6.932036 -8060 2277 4 0 -2.863656 -10.910261 7.899378 -8061 2278 6 0 21.328627 5.452241 -5.411722 -8062 2278 4 0 20.702591 5.402774 -4.696060 -8063 2278 4 0 21.847512 4.616832 -5.258353 -8064 2279 6 0 25.174339 -4.700786 4.319189 -8065 2279 4 0 25.475426 -5.192515 3.516499 -8066 2279 4 0 24.849082 -5.290270 5.019481 -8067 2280 6 0 -20.973509 17.475850 18.235841 -8068 2280 4 0 -20.795645 16.959839 19.077904 -8069 2280 4 0 -21.937194 17.741268 18.405829 -8070 2281 6 0 -17.032214 -4.404070 -16.615581 -8071 2281 4 0 -18.027750 -4.237947 -16.713048 -8072 2281 4 0 -16.825738 -5.153522 -17.221012 -8073 2282 6 0 5.077355 4.864838 15.841740 -8074 2282 4 0 5.888380 4.293000 15.916342 -8075 2282 4 0 5.502771 5.719564 15.999661 -8076 2283 6 0 14.150746 7.193364 7.768856 -8077 2283 4 0 13.512887 7.556242 8.342946 -8078 2283 4 0 13.719519 6.964481 6.933299 -8079 2284 6 0 24.979967 10.864144 -3.827107 -8080 2284 4 0 25.315666 11.790605 -3.820018 -8081 2284 4 0 24.586117 10.647324 -4.635764 -8082 2285 6 0 -19.307013 7.977617 -19.097895 -8083 2285 4 0 -18.730894 8.713079 -18.873103 -8084 2285 4 0 -19.574094 8.132279 -20.016040 -8085 2286 6 0 24.806727 -12.761480 -19.492468 -8086 2286 4 0 24.884669 -13.553250 -18.933552 -8087 2286 4 0 23.868023 -12.741257 -19.679606 -8088 2287 6 0 -16.494024 -10.263681 -3.455262 -8089 2287 4 0 -16.433900 -9.520847 -4.087773 -8090 2287 4 0 -16.512097 -9.942519 -2.552121 -8091 2288 6 0 7.239107 -8.678420 15.402099 -8092 2288 4 0 8.128327 -8.620090 15.837696 -8093 2288 4 0 7.413730 -9.358400 14.729775 -8094 2289 6 0 -11.637039 -18.299602 1.445919 -8095 2289 4 0 -11.805502 -17.472273 0.974361 -8096 2289 4 0 -10.835652 -18.063314 1.950128 -8097 2290 6 0 3.539913 -9.008378 14.869684 -8098 2290 4 0 3.690725 -8.667083 13.987735 -8099 2290 4 0 3.786240 -8.275061 15.438308 -8100 2291 6 0 25.309639 -20.139973 8.261630 -8101 2291 4 0 26.025004 -20.789387 8.243372 -8102 2291 4 0 24.785538 -20.229959 9.088332 -8103 2292 6 0 -11.167618 15.368263 17.768795 -8104 2292 4 0 -11.447760 15.042536 16.890680 -8105 2292 4 0 -10.221576 15.243374 17.719247 -8106 2293 6 0 15.783799 16.252451 16.657327 -8107 2293 4 0 16.469650 16.826129 16.279349 -8108 2293 4 0 15.146657 16.166099 16.010457 -8109 2294 6 0 -23.087822 12.851874 11.524125 -8110 2294 4 0 -22.550515 13.272517 12.247361 -8111 2294 4 0 -23.433828 13.646077 11.045696 -8112 2295 6 0 18.224787 5.336233 10.181216 -8113 2295 4 0 17.768669 5.758936 9.423686 -8114 2295 4 0 17.527118 5.295554 10.828797 -8115 2296 6 0 23.091715 -2.832106 10.928215 -8116 2296 4 0 23.963022 -3.221214 10.847174 -8117 2296 4 0 23.111421 -1.957098 10.500452 -8118 2297 6 0 -8.122293 -8.153763 8.762475 -8119 2297 4 0 -8.486311 -7.377176 8.275878 -8120 2297 4 0 -7.842547 -7.967759 9.693098 -8121 2298 6 0 -23.746981 -1.978340 20.222446 -8122 2298 4 0 -24.119623 -2.610408 19.587105 -8123 2298 4 0 -22.788269 -2.052555 20.075719 -8124 2299 6 0 15.889034 -8.818090 19.786354 -8125 2299 4 0 16.162821 -8.087882 19.189549 -8126 2299 4 0 16.517604 -9.567302 19.583898 -8127 2300 6 0 -22.434542 -1.993577 2.665229 -8128 2300 4 0 -21.639169 -2.320398 3.125908 -8129 2300 4 0 -22.887302 -1.544538 3.368374 -8130 2301 6 0 -4.294135 12.198286 3.905187 -8131 2301 4 0 -3.524217 12.481373 3.400532 -8132 2301 4 0 -4.358032 12.831366 4.583192 -8133 2302 6 0 -10.287802 2.763656 12.120543 -8134 2302 4 0 -10.140580 1.873404 11.826731 -8135 2302 4 0 -10.262187 2.731368 13.100818 -8136 2303 6 0 11.514142 11.933521 -10.265166 -8137 2303 4 0 11.257715 12.740478 -9.772518 -8138 2303 4 0 11.449563 11.209135 -9.611780 -8139 2304 6 0 4.752686 10.041816 10.494911 -8140 2304 4 0 5.000099 10.228340 11.405783 -8141 2304 4 0 4.465587 10.901799 10.118351 -8142 2305 6 0 17.099352 -16.900118 20.580015 -8143 2305 4 0 16.248341 -17.056394 20.914403 -8144 2305 4 0 16.964732 -16.230792 19.853524 -8145 2306 6 0 -6.880763 4.754709 14.803663 -8146 2306 4 0 -7.780049 5.017298 14.837120 -8147 2306 4 0 -6.602000 5.380408 14.109963 -8148 2307 6 0 18.852257 3.117416 3.416315 -8149 2307 4 0 18.466519 2.248205 3.599368 -8150 2307 4 0 19.770424 2.988919 3.600584 -8151 2308 6 0 -19.565302 -15.452338 -12.857316 -8152 2308 4 0 -19.465174 -14.703294 -13.434992 -8153 2308 4 0 -18.713185 -15.861077 -12.849765 -8154 2309 6 0 -22.600437 -10.691469 12.850297 -8155 2309 4 0 -23.397550 -10.659087 13.302216 -8156 2309 4 0 -22.787116 -11.067370 12.012734 -8157 2310 6 0 -21.982415 -13.573385 -4.311729 -8158 2310 4 0 -22.884778 -13.924822 -4.053153 -8159 2310 4 0 -21.591210 -13.340585 -3.436663 -8160 2311 6 0 -9.482768 -17.119153 10.316888 -8161 2311 4 0 -10.089752 -16.593034 9.704444 -8162 2311 4 0 -9.402425 -17.912940 9.854825 -8163 2312 6 0 14.779023 -10.205617 3.169184 -8164 2312 4 0 14.033719 -9.624095 2.903870 -8165 2312 4 0 14.431082 -10.650018 3.996000 -8166 2313 6 0 -23.065785 7.688851 4.302863 -8167 2313 4 0 -23.519497 6.846326 4.179947 -8168 2313 4 0 -23.396856 8.243234 3.642471 -8169 2314 6 0 -12.420110 17.313613 -9.713155 -8170 2314 4 0 -13.364634 17.232909 -9.649724 -8171 2314 4 0 -12.198343 18.200726 -10.087577 -8172 2315 6 0 13.807063 -18.735375 -18.358481 -8173 2315 4 0 13.518261 -18.146104 -17.665040 -8174 2315 4 0 14.609291 -19.207101 -18.003404 -8175 2316 6 0 10.712591 7.098327 3.970951 -8176 2316 4 0 10.424496 6.939336 4.829144 -8177 2316 4 0 10.486897 6.231102 3.501449 -8178 2317 6 0 -26.193278 8.679696 17.901485 -8179 2317 4 0 -25.410504 8.357458 17.457879 -8180 2317 4 0 -26.819464 8.901614 17.137834 -8181 2318 6 0 19.451507 -12.567707 -15.280479 -8182 2318 4 0 19.003766 -12.254527 -14.428024 -8183 2318 4 0 20.294592 -12.135913 -15.254851 -8184 2319 6 0 -14.332854 -0.923507 14.572189 -8185 2319 4 0 -14.044747 -0.194105 14.037975 -8186 2319 4 0 -13.492568 -1.193300 14.988120 -8187 2320 6 0 -8.730522 14.085678 -10.180676 -8188 2320 4 0 -8.524068 13.138626 -10.211460 -8189 2320 4 0 -9.480763 14.191583 -10.748692 -8190 2321 6 0 -18.278878 -5.590157 8.386336 -8191 2321 4 0 -18.405152 -4.662040 8.661744 -8192 2321 4 0 -17.563780 -5.717750 9.039776 -8193 2322 6 0 -24.210906 -9.471833 -3.828648 -8194 2322 4 0 -23.595084 -9.970587 -4.330527 -8195 2322 4 0 -23.577826 -8.951405 -3.327851 -8196 2323 6 0 -7.110604 8.838398 10.174602 -8197 2323 4 0 -7.782545 9.119070 9.563121 -8198 2323 4 0 -6.874836 7.936950 10.110612 -8199 2324 6 0 24.419141 17.000522 -10.922840 -8200 2324 4 0 23.664703 16.933938 -11.553390 -8201 2324 4 0 24.021846 17.152778 -10.052143 -8202 2325 6 0 -14.488243 5.098469 4.479912 -8203 2325 4 0 -13.709956 5.650481 4.473177 -8204 2325 4 0 -14.910202 5.058380 3.581039 -8205 2326 6 0 -2.415807 -13.812743 6.907700 -8206 2326 4 0 -2.596718 -13.309899 6.111317 -8207 2326 4 0 -3.251745 -14.327682 7.109165 -8208 2327 6 0 -18.926033 -9.523396 -18.297588 -8209 2327 4 0 -18.539154 -9.705366 -19.167443 -8210 2327 4 0 -19.196583 -8.616444 -18.314206 -8211 2328 6 0 23.648770 -10.033565 -19.143545 -8212 2328 4 0 23.763359 -9.374241 -19.822180 -8213 2328 4 0 24.359914 -10.609348 -19.397407 -8214 2329 6 0 0.735457 -17.444252 -0.196869 -8215 2329 4 0 1.204966 -17.103235 -0.982724 -8216 2329 4 0 -0.166461 -17.675326 -0.501142 -8217 2330 6 0 15.977053 8.980217 19.819118 -8218 2330 4 0 15.510910 8.262919 19.411773 -8219 2330 4 0 15.638831 9.774710 19.469638 -8220 2331 6 0 -21.818391 12.562887 20.032627 -8221 2331 4 0 -22.085628 11.618258 19.842948 -8222 2331 4 0 -20.827992 12.718524 19.975012 -8223 2332 6 0 7.039712 -16.964990 -15.541675 -8224 2332 4 0 6.809451 -17.534371 -14.799854 -8225 2332 4 0 7.846558 -16.584905 -15.213738 -8226 2333 6 0 -10.516103 -19.359216 -4.984483 -8227 2333 4 0 -11.487322 -19.499249 -4.976576 -8228 2333 4 0 -10.316797 -19.130113 -5.876399 -8229 2334 6 0 -15.712544 -18.195821 -16.791463 -8230 2334 4 0 -15.386725 -17.379305 -16.972966 -8231 2334 4 0 -16.234052 -18.450302 -17.577749 -8232 2335 6 0 20.375630 2.207122 -4.920313 -8233 2335 4 0 20.216775 1.456591 -4.343459 -8234 2335 4 0 20.280207 1.853389 -5.797632 -8235 2336 6 0 22.857055 19.552693 3.665905 -8236 2336 4 0 22.878248 19.783393 4.649190 -8237 2336 4 0 23.742572 19.802123 3.384761 -8238 2337 6 0 -23.291098 12.571857 -7.317143 -8239 2337 4 0 -23.912608 13.233941 -6.880268 -8240 2337 4 0 -22.652186 12.332429 -6.543330 -8241 2338 6 0 12.984606 10.221427 -16.808099 -8242 2338 4 0 13.667678 9.959368 -16.244780 -8243 2338 4 0 12.511584 9.401797 -16.883576 -8244 2339 6 0 27.270245 0.587979 13.208753 -8245 2339 4 0 27.702404 -0.278797 13.294250 -8246 2339 4 0 26.279511 0.464606 13.258979 -8247 2340 6 0 5.657499 -16.976293 13.990530 -8248 2340 4 0 4.705984 -16.954734 13.883042 -8249 2340 4 0 5.909722 -16.502798 14.791441 -8250 2341 6 0 22.979947 17.951763 0.527007 -8251 2341 4 0 22.428004 18.639190 0.176667 -8252 2341 4 0 22.281623 17.341478 0.914453 -8253 2342 6 0 -21.891524 -16.491873 5.462047 -8254 2342 4 0 -21.611111 -15.606060 5.550776 -8255 2342 4 0 -22.025511 -16.701806 4.529568 -8256 2343 6 0 8.528721 7.946876 17.483315 -8257 2343 4 0 9.390982 8.385502 17.311853 -8258 2343 4 0 8.485801 7.948173 18.426233 -8259 2344 6 0 26.823691 0.686378 2.887481 -8260 2344 4 0 26.841167 0.391628 3.805678 -8261 2344 4 0 26.597454 1.662650 2.917193 -8262 2345 6 0 -4.950286 -7.194323 15.626699 -8263 2345 4 0 -4.352839 -6.657887 15.072055 -8264 2345 4 0 -5.857741 -7.272638 15.219003 -8265 2346 6 0 -8.714977 5.000352 11.128210 -8266 2346 4 0 -9.170865 4.207326 11.391243 -8267 2346 4 0 -8.026665 4.716136 10.523111 -8268 2347 6 0 -21.206733 -3.279994 -6.524932 -8269 2347 4 0 -20.929590 -2.947470 -5.608742 -8270 2347 4 0 -21.369929 -2.564467 -7.124044 -8271 2348 6 0 -24.169876 -16.066494 -0.699927 -8272 2348 4 0 -23.893194 -16.983386 -0.501792 -8273 2348 4 0 -23.818535 -15.566437 0.016995 -8274 2349 6 0 -4.762418 0.978128 -17.450230 -8275 2349 4 0 -5.459419 0.534407 -17.851461 -8276 2349 4 0 -3.876584 0.532188 -17.586085 -8277 2350 6 0 -23.690384 0.720873 19.030161 -8278 2350 4 0 -24.529537 0.743437 18.583662 -8279 2350 4 0 -23.655688 -0.011267 19.593259 -8280 2351 6 0 -15.912159 -12.362138 19.142289 -8281 2351 4 0 -16.860673 -12.328378 19.455109 -8282 2351 4 0 -15.543971 -13.259386 19.298591 -8283 2352 6 0 21.658993 17.599149 -16.014662 -8284 2352 4 0 22.041785 18.520354 -15.943036 -8285 2352 4 0 20.778035 17.749200 -16.427622 -8286 2353 6 0 -19.912308 -13.107035 -14.484614 -8287 2353 4 0 -19.659870 -12.430860 -13.832450 -8288 2353 4 0 -19.896529 -12.695904 -15.325705 -8289 2354 6 0 -24.276277 -16.465070 11.658834 -8290 2354 4 0 -24.414709 -16.008322 12.561598 -8291 2354 4 0 -24.456920 -15.764788 11.022016 -8292 2355 6 0 7.338121 15.134359 12.353797 -8293 2355 4 0 6.756929 14.359360 12.209000 -8294 2355 4 0 7.312954 15.621960 11.560650 -8295 2356 6 0 16.833359 -15.091185 7.049718 -8296 2356 4 0 17.575828 -15.201998 7.598156 -8297 2356 4 0 17.181929 -14.913423 6.159696 -8298 2357 6 0 -25.459827 -8.831619 -10.909942 -8299 2357 4 0 -26.346699 -9.154571 -11.164077 -8300 2357 4 0 -25.113612 -9.635356 -10.548749 -8301 2358 6 0 14.104756 2.118788 -11.000106 -8302 2358 4 0 14.145828 1.958779 -9.996196 -8303 2358 4 0 13.664160 1.315915 -11.343904 -8304 2359 6 0 15.657145 -19.646810 2.896166 -8305 2359 4 0 16.434824 -20.115913 3.051182 -8306 2359 4 0 15.028606 -20.220332 2.452201 -8307 2360 6 0 23.725885 -12.794695 -0.945499 -8308 2360 4 0 23.281780 -11.890719 -0.926868 -8309 2360 4 0 24.708749 -12.621299 -0.988388 -8310 2361 6 0 -16.865263 14.164216 13.710722 -8311 2361 4 0 -17.362193 13.380801 13.838272 -8312 2361 4 0 -16.087062 13.922374 13.209541 -8313 2362 6 0 -19.739666 -15.403180 15.520974 -8314 2362 4 0 -20.455057 -15.397351 14.881774 -8315 2362 4 0 -20.082522 -14.871806 16.282279 -8316 2363 6 0 19.096837 -7.172079 16.486018 -8317 2363 4 0 19.407501 -6.257692 16.370379 -8318 2363 4 0 19.040095 -7.459208 15.607247 -8319 2364 6 0 18.172332 -12.158590 -6.201699 -8320 2364 4 0 18.304057 -11.335714 -6.732706 -8321 2364 4 0 19.035089 -12.338188 -5.764950 -8322 2365 6 0 -0.868698 -19.642469 -16.996885 -8323 2365 4 0 -1.363468 -20.113317 -17.713302 -8324 2365 4 0 -1.471726 -19.010491 -16.662422 -8325 2366 6 0 -24.645397 10.341459 -7.907386 -8326 2366 4 0 -25.403222 10.434913 -7.336084 -8327 2366 4 0 -24.138877 11.164300 -7.816681 -8328 2367 6 0 -16.672238 -8.013464 18.598945 -8329 2367 4 0 -16.066967 -8.743970 18.706313 -8330 2367 4 0 -16.176282 -7.259661 18.335226 -8331 2368 6 0 22.487322 14.165266 -7.478753 -8332 2368 4 0 22.557098 13.462620 -8.195467 -8333 2368 4 0 23.077183 13.896514 -6.804199 -8334 2369 6 0 -16.969008 0.617904 2.364611 -8335 2369 4 0 -17.366120 1.196458 3.012496 -8336 2369 4 0 -16.204897 0.132723 2.713670 -8337 2370 6 0 -16.105014 -0.776954 10.291984 -8338 2370 4 0 -16.257341 0.223589 10.333435 -8339 2370 4 0 -16.822249 -1.143779 10.739482 -8340 2371 6 0 -1.572980 -19.983373 -2.947973 -8341 2371 4 0 -1.992560 -20.034455 -3.807433 -8342 2371 4 0 -0.620010 -19.746082 -3.116100 -8343 2372 6 0 -14.996679 12.712532 -5.614114 -8344 2372 4 0 -15.916609 12.454215 -5.655277 -8345 2372 4 0 -14.599913 12.087283 -6.181656 -8346 2373 6 0 -6.550042 17.243085 -1.311911 -8347 2373 4 0 -7.370137 17.795578 -1.470109 -8348 2373 4 0 -6.675338 16.814239 -0.435288 -8349 2374 6 0 -22.961585 9.343900 -1.894881 -8350 2374 4 0 -22.135413 9.413165 -2.387021 -8351 2374 4 0 -23.019360 8.393337 -1.628379 -8352 2375 6 0 -23.240008 -19.417092 6.368497 -8353 2375 4 0 -23.612098 -20.201035 6.825569 -8354 2375 4 0 -23.684109 -18.690648 6.877699 -8355 2376 6 0 -3.975590 2.585287 -20.330975 -8356 2376 4 0 -3.555653 1.727030 -20.090182 -8357 2376 4 0 -3.232879 3.201768 -20.459323 -8358 2377 6 0 13.624748 -19.863473 12.144241 -8359 2377 4 0 14.457772 -19.530528 12.546517 -8360 2377 4 0 12.915028 -19.260602 12.383266 -8361 2378 6 0 23.620886 -17.871879 14.645268 -8362 2378 4 0 24.200914 -17.421417 15.259794 -8363 2378 4 0 23.549736 -17.298378 13.830439 -8364 2379 6 0 9.321358 4.851563 -10.671349 -8365 2379 4 0 8.417643 4.825903 -10.980879 -8366 2379 4 0 9.236659 5.389642 -9.880988 -8367 2380 6 0 16.676932 -15.595371 18.042582 -8368 2380 4 0 15.776328 -15.312249 17.740520 -8369 2380 4 0 17.268778 -14.856833 17.976717 -8370 2381 6 0 5.120016 13.517889 11.545409 -8371 2381 4 0 4.343182 13.415911 12.098245 -8372 2381 4 0 4.693345 13.853732 10.680472 -8373 2382 6 0 -25.377039 -18.256471 8.076220 -8374 2382 4 0 -25.781276 -18.544454 8.897977 -8375 2382 4 0 -25.633977 -17.323858 7.972468 -8376 2383 6 0 0.809058 7.564416 -14.066874 -8377 2383 4 0 0.916059 7.331613 -13.143223 -8378 2383 4 0 1.470333 8.274989 -14.200531 -8379 2384 6 0 15.418267 9.781452 0.490529 -8380 2384 4 0 16.087047 9.430117 -0.107289 -8381 2384 4 0 15.469266 9.208927 1.264230 -8382 2385 6 0 18.819099 0.059487 -7.791298 -8383 2385 4 0 18.409799 -0.334456 -8.599701 -8384 2385 4 0 18.505418 0.975155 -7.815461 -8385 2386 6 0 18.734857 -11.129665 -12.743525 -8386 2386 4 0 19.553404 -11.223386 -12.120138 -8387 2386 4 0 18.518443 -10.240054 -12.855533 -8388 2387 6 0 -6.542631 16.490309 -5.774007 -8389 2387 4 0 -7.424909 16.908246 -5.691889 -8390 2387 4 0 -6.518994 16.127379 -6.676862 -8391 2388 6 0 -11.192140 0.472205 -12.639446 -8392 2388 4 0 -12.103697 0.267919 -12.529950 -8393 2388 4 0 -10.710800 -0.374282 -12.557572 -8394 2389 6 0 16.720488 13.886958 -20.533060 -8395 2389 4 0 16.205223 14.702224 -20.376437 -8396 2389 4 0 16.691127 13.403715 -19.702754 -8397 2390 6 0 17.388334 13.435587 -15.657568 -8398 2390 4 0 18.130270 13.582226 -16.327461 -8399 2390 4 0 17.639406 12.621568 -15.195169 -8400 2391 6 0 -6.834253 10.232886 -18.214238 -8401 2391 4 0 -6.903061 10.582756 -17.312839 -8402 2391 4 0 -7.065760 10.977380 -18.753726 -8403 2392 6 0 -26.724908 17.912645 17.886470 -8404 2392 4 0 -25.957218 18.458136 17.628812 -8405 2392 4 0 -26.362765 17.099535 18.218344 -8406 2393 6 0 -0.903403 -3.732795 -18.221524 -8407 2393 4 0 0.015845 -3.986413 -18.434069 -8408 2393 4 0 -1.449749 -4.292278 -18.787390 -8409 2394 6 0 8.478846 18.397280 11.407292 -8410 2394 4 0 7.633351 18.651942 11.041557 -8411 2394 4 0 9.129265 18.582960 10.779627 -8412 2395 6 0 -9.044898 12.879599 11.037060 -8413 2395 4 0 -8.299458 12.613036 10.480728 -8414 2395 4 0 -9.785562 12.774996 10.383091 -8415 2396 6 0 16.212680 8.794036 14.029672 -8416 2396 4 0 15.473945 9.288728 13.836685 -8417 2396 4 0 17.028607 9.276518 14.011973 -8418 2397 6 0 -12.268552 13.361223 -20.521861 -8419 2397 4 0 -13.186409 13.158881 -20.579852 -8420 2397 4 0 -12.306685 14.297827 -20.782380 -8421 2398 6 0 21.001802 -1.484392 16.467423 -8422 2398 4 0 20.737187 -1.861020 17.327615 -8423 2398 4 0 21.860569 -1.911455 16.193850 -8424 2399 6 0 -9.356304 11.431280 -8.974418 -8425 2399 4 0 -8.659737 10.769575 -8.653703 -8426 2399 4 0 -9.803431 11.675976 -8.182315 -8427 2400 6 0 26.948445 8.871461 -17.613543 -8428 2400 4 0 27.531052 9.681414 -17.576254 -8429 2400 4 0 27.482335 8.261182 -17.042391 -8430 2401 6 0 18.976966 2.434133 -12.543728 -8431 2401 4 0 18.194377 2.424795 -11.982928 -8432 2401 4 0 19.117316 3.368724 -12.808991 -8433 2402 6 0 8.245403 -12.742057 19.723005 -8434 2402 4 0 8.144484 -13.022949 20.662655 -8435 2402 4 0 7.837153 -13.446042 19.196869 -8436 2403 6 0 9.039756 -7.597109 18.653269 -8437 2403 4 0 8.770812 -7.616934 19.576989 -8438 2403 4 0 9.066589 -6.664479 18.418706 -8439 2404 6 0 10.189217 11.926636 11.235547 -8440 2404 4 0 10.233257 12.873995 11.065027 -8441 2404 4 0 9.236322 11.798256 11.121031 -8442 2405 6 0 -19.235380 -20.224186 -5.743147 -8443 2405 4 0 -19.963520 -19.550478 -5.766714 -8444 2405 4 0 -18.597575 -19.892671 -5.077870 -8445 2406 6 0 17.081164 12.504780 -5.519702 -8446 2406 4 0 17.317528 12.830762 -4.628825 -8447 2406 4 0 17.566228 11.707478 -5.694496 -8448 2407 6 0 -17.833354 13.022736 -7.625662 -8449 2407 4 0 -18.435075 12.266236 -7.562794 -8450 2407 4 0 -17.596760 13.126821 -6.753333 -8451 2408 6 0 -16.003848 -12.359888 13.230149 -8452 2408 4 0 -16.195567 -13.201470 12.841886 -8453 2408 4 0 -16.339851 -12.416796 14.117412 -8454 2409 6 0 0.176516 -12.560501 -12.425472 -8455 2409 4 0 0.737394 -13.294947 -12.707192 -8456 2409 4 0 -0.008554 -11.988851 -13.210535 -8457 2410 6 0 15.945838 0.256833 12.759642 -8458 2410 4 0 15.315992 0.578271 12.079867 -8459 2410 4 0 15.303877 -0.130234 13.393857 -8460 2411 6 0 3.991270 11.948196 8.788506 -8461 2411 4 0 4.354131 11.617913 7.978688 -8462 2411 4 0 3.989725 12.878797 8.755522 -8463 2412 6 0 24.041021 -18.227784 19.978317 -8464 2412 4 0 23.613150 -19.023367 19.715938 -8465 2412 4 0 23.421760 -17.634320 20.391706 -8466 2413 6 0 4.480569 2.293232 -17.929461 -8467 2413 4 0 4.737918 2.408019 -18.806644 -8468 2413 4 0 3.697109 2.859289 -17.719771 -8469 2414 6 0 -21.893430 -14.247042 -8.071389 -8470 2414 4 0 -21.621325 -13.340615 -8.179140 -8471 2414 4 0 -21.245096 -14.771492 -7.611926 -8472 2415 6 0 11.391170 -20.197067 6.087190 -8473 2415 4 0 12.332346 -20.225253 6.056925 -8474 2415 4 0 11.169435 -19.741912 5.268989 -8475 2416 6 0 -17.767521 13.536365 -18.283934 -8476 2416 4 0 -17.676219 14.086222 -17.468766 -8477 2416 4 0 -17.016627 12.978563 -18.394451 -8478 2417 6 0 5.005032 -20.873389 -8.545316 -8479 2417 4 0 4.212566 -20.486316 -8.983260 -8480 2417 4 0 4.690972 -21.402526 -7.849785 -8481 2418 6 0 18.199775 -4.330757 -14.972084 -8482 2418 4 0 17.789625 -3.483346 -14.772916 -8483 2418 4 0 18.849294 -4.135351 -15.681645 -8484 2419 6 0 19.744670 16.153747 4.684702 -8485 2419 4 0 18.926975 15.872879 5.113981 -8486 2419 4 0 20.486481 15.836577 5.222155 -8487 2420 6 0 -0.915970 -9.397508 15.585411 -8488 2420 4 0 -0.105843 -9.703483 16.010408 -8489 2420 4 0 -1.285330 -8.812368 16.200287 -8490 2421 6 0 -23.858596 3.816844 -5.177897 -8491 2421 4 0 -23.879687 4.029482 -4.237763 -8492 2421 4 0 -24.276504 2.954820 -5.342696 -8493 2422 6 0 11.838596 14.359137 5.947499 -8494 2422 4 0 11.923450 13.438110 5.725008 -8495 2422 4 0 12.426438 14.419837 6.789373 -8496 2423 6 0 -24.516087 -8.212903 6.467548 -8497 2423 4 0 -24.905939 -8.825058 7.092971 -8498 2423 4 0 -23.896260 -8.737352 6.010203 -8499 2424 6 0 12.794509 0.536645 -20.243875 -8500 2424 4 0 12.046024 0.975194 -20.739130 -8501 2424 4 0 12.750658 0.998686 -19.404096 -8502 2425 6 0 -2.221545 7.221132 -15.714309 -8503 2425 4 0 -1.564134 7.922819 -15.440249 -8504 2425 4 0 -1.907716 6.786282 -16.499729 -8505 2426 6 0 -15.262103 -1.025135 3.744497 -8506 2426 4 0 -15.665604 -1.870757 3.765630 -8507 2426 4 0 -15.328619 -0.606155 4.583614 -8508 2427 6 0 20.108494 -9.991193 -19.911625 -8509 2427 4 0 19.428700 -9.825766 -19.213627 -8510 2427 4 0 20.361712 -9.133136 -20.249113 -8511 2428 6 0 12.867409 -6.904802 4.443594 -8512 2428 4 0 12.264306 -6.203776 4.409753 -8513 2428 4 0 13.784027 -6.565705 4.350727 -8514 2429 6 0 24.058876 -8.248822 -17.051222 -8515 2429 4 0 23.730319 -9.008822 -17.519701 -8516 2429 4 0 24.878618 -8.026208 -17.519719 -8517 2430 6 0 -14.847363 -1.001783 -19.170682 -8518 2430 4 0 -15.449801 -0.826718 -19.858698 -8519 2430 4 0 -15.320403 -1.330455 -18.387373 -8520 2431 6 0 15.553192 2.814264 -3.465226 -8521 2431 4 0 14.896744 3.481739 -3.135135 -8522 2431 4 0 16.160657 3.336721 -3.991437 -8523 2432 6 0 -13.974002 9.185648 16.956055 -8524 2432 4 0 -13.130305 8.696408 16.805351 -8525 2432 4 0 -14.376866 8.733537 17.688722 -8526 2433 6 0 -11.797740 -0.516894 9.586967 -8527 2433 4 0 -12.628798 -0.925501 9.242559 -8528 2433 4 0 -11.646717 0.185675 8.970795 -8529 2434 6 0 24.903028 -3.994226 -11.118622 -8530 2434 4 0 23.952025 -4.106045 -10.736954 -8531 2434 4 0 24.790476 -3.484811 -11.918719 -8532 2435 6 0 2.220549 5.328975 16.431794 -8533 2435 4 0 1.808604 4.568086 16.851941 -8534 2435 4 0 3.174924 5.179737 16.323538 -8535 2436 6 0 1.396616 14.937103 19.138615 -8536 2436 4 0 0.558182 14.600636 18.844822 -8537 2436 4 0 1.257435 14.884393 20.102246 -8538 2437 6 0 -20.671636 -15.366474 -18.208204 -8539 2437 4 0 -21.380399 -15.277369 -18.859413 -8540 2437 4 0 -20.736983 -16.181001 -17.742657 -8541 2438 6 0 -13.058044 -20.095582 -4.362430 -8542 2438 4 0 -13.024712 -20.612656 -3.543798 -8543 2438 4 0 -13.691481 -19.389144 -4.075579 -8544 2439 6 0 -15.561123 -4.237765 12.636329 -8545 2439 4 0 -16.268647 -3.833291 13.167415 -8546 2439 4 0 -15.110937 -3.419743 12.299589 -8547 2440 6 0 -24.759181 -6.035582 2.884287 -8548 2440 4 0 -25.250513 -6.831996 2.887098 -8549 2440 4 0 -25.305365 -5.369041 2.551951 -8550 2441 6 0 -4.620853 12.299627 11.037908 -8551 2441 4 0 -4.440765 13.138122 11.409774 -8552 2441 4 0 -4.916886 11.692935 11.716163 -8553 2442 6 0 -16.569703 1.526861 -7.254759 -8554 2442 4 0 -16.695783 1.936301 -8.074606 -8555 2442 4 0 -16.882141 0.632206 -7.402201 -8556 2443 6 0 23.467888 -9.654261 -12.695108 -8557 2443 4 0 24.029597 -9.067666 -13.167615 -8558 2443 4 0 23.123232 -9.217050 -11.833851 -8559 2444 6 0 -18.429010 -3.061156 8.894173 -8560 2444 4 0 -19.027972 -2.389846 8.642550 -8561 2444 4 0 -18.106797 -2.785618 9.787642 -8562 2445 6 0 -19.107978 15.849121 -9.475466 -8563 2445 4 0 -18.864733 15.428418 -8.655322 -8564 2445 4 0 -18.505127 16.629956 -9.591908 -8565 2446 6 0 22.274682 -20.084251 -0.325198 -8566 2446 4 0 22.135094 -19.096797 -0.356152 -8567 2446 4 0 23.083213 -20.126631 -0.830959 -8568 2447 6 0 24.369325 -3.216706 -4.897640 -8569 2447 4 0 25.222404 -2.719894 -4.895318 -8570 2447 4 0 24.445157 -3.895914 -4.229474 -8571 2448 6 0 -9.139981 -19.842644 16.043544 -8572 2448 4 0 -8.820691 -19.672535 15.122253 -8573 2448 4 0 -9.672340 -20.660357 15.944536 -8574 2449 6 0 -20.896241 -15.764905 -2.307185 -8575 2449 4 0 -21.812479 -15.705631 -2.446120 -8576 2449 4 0 -20.844603 -15.784793 -1.327016 -8577 2450 6 0 7.223156 -5.748983 -18.629737 -8578 2450 4 0 7.206095 -4.844227 -18.946828 -8579 2450 4 0 7.989785 -5.796585 -18.164482 -8580 2451 6 0 -25.843140 -1.143611 9.149078 -8581 2451 4 0 -25.886005 -1.657786 8.289135 -8582 2451 4 0 -25.272098 -1.801443 9.596520 -8583 2452 6 0 -25.617505 11.234770 1.302402 -8584 2452 4 0 -26.519698 11.382080 0.891273 -8585 2452 4 0 -25.709717 11.496799 2.260967 -8586 2453 6 0 -24.008718 3.700426 14.077463 -8587 2453 4 0 -23.636744 2.818441 14.397144 -8588 2453 4 0 -24.193959 3.715212 13.098008 -8589 2454 6 0 -25.288161 15.287096 -3.633466 -8590 2454 4 0 -24.701801 15.181375 -2.917528 -8591 2454 4 0 -24.884059 15.980496 -4.222265 -8592 2455 6 0 -18.371976 0.316233 -12.753606 -8593 2455 4 0 -17.540257 0.805382 -12.677195 -8594 2455 4 0 -18.928928 0.935156 -13.269213 -8595 2456 6 0 -7.333443 0.117823 -18.660950 -8596 2456 4 0 -8.021021 0.414744 -18.077567 -8597 2456 4 0 -7.588161 -0.774648 -18.860400 -8598 2457 6 0 7.916046 -4.737118 -11.962175 -8599 2457 4 0 7.823803 -4.591176 -10.961540 -8600 2457 4 0 8.487079 -3.962811 -12.242330 -8601 2458 6 0 -16.065017 -17.683748 12.637430 -8602 2458 4 0 -17.011987 -17.735296 12.722608 -8603 2458 4 0 -15.831448 -18.384474 11.953837 -8604 2459 6 0 21.305339 -15.655490 -5.124093 -8605 2459 4 0 20.807407 -16.186834 -5.710639 -8606 2459 4 0 21.624819 -16.214868 -4.447516 -8607 2460 6 0 -26.764181 -18.581640 -16.921151 -8608 2460 4 0 -26.740653 -17.883931 -16.251171 -8609 2460 4 0 -25.889831 -19.016845 -16.852743 -8610 2461 6 0 -16.578359 -2.340901 14.589648 -8611 2461 4 0 -16.492161 -3.040832 15.326073 -8612 2461 4 0 -15.697628 -1.820257 14.616293 -8613 2462 6 0 26.043166 5.997514 -3.795215 -8614 2462 4 0 26.451990 6.864435 -3.803447 -8615 2462 4 0 26.795850 5.513156 -3.370169 -8616 2463 6 0 -2.866251 17.249672 -19.402655 -8617 2463 4 0 -2.050135 17.665045 -19.652864 -8618 2463 4 0 -2.832242 16.313071 -19.542218 -8619 2464 6 0 -15.459807 -11.710100 -10.460216 -8620 2464 4 0 -14.969300 -11.366276 -9.661631 -8621 2464 4 0 -16.276955 -12.017208 -9.984012 -8622 2465 6 0 19.650264 6.930828 12.762298 -8623 2465 4 0 19.873188 6.462285 13.595929 -8624 2465 4 0 20.303044 6.550090 12.177619 -8625 2466 6 0 -22.570365 -4.412836 -1.811273 -8626 2466 4 0 -22.171357 -5.263031 -1.838077 -8627 2466 4 0 -22.826216 -4.391044 -0.929643 -8628 2467 6 0 -15.225393 0.344956 6.093949 -8629 2467 4 0 -14.897061 1.256657 6.050627 -8630 2467 4 0 -14.862108 -0.118094 6.882677 -8631 2468 6 0 -26.214592 10.149434 -12.755279 -8632 2468 4 0 -27.155901 10.181440 -12.954282 -8633 2468 4 0 -26.080437 9.913123 -11.832638 -8634 2469 6 0 -26.639137 -20.836220 10.642324 -8635 2469 4 0 -26.244776 -19.942202 10.604043 -8636 2469 4 0 -26.010374 -21.363114 10.100802 -8637 2470 6 0 27.068918 -13.224704 20.865450 -8638 2470 4 0 27.744233 -12.679284 21.316162 -8639 2470 4 0 26.232445 -12.945570 21.191563 -8640 2471 6 0 -15.301597 13.975513 -8.460131 -8641 2471 4 0 -14.952706 13.782668 -7.567357 -8642 2471 4 0 -16.244257 13.821878 -8.381549 -8643 2472 6 0 25.467875 11.658105 -7.593959 -8644 2472 4 0 24.761290 11.160502 -7.120317 -8645 2472 4 0 25.002961 12.057880 -8.288551 -8646 2473 6 0 -27.479869 -4.262964 -20.483737 -8647 2473 4 0 -26.752473 -4.746654 -20.858210 -8648 2473 4 0 -27.165915 -3.756567 -19.782830 -8649 2474 6 0 -24.406173 20.048905 -13.265390 -8650 2474 4 0 -23.845919 19.394517 -12.782711 -8651 2474 4 0 -25.326791 19.952777 -13.266139 -8652 2475 6 0 -12.606740 1.855396 14.924299 -8653 2475 4 0 -13.099296 2.292250 15.633985 -8654 2475 4 0 -13.213129 1.841828 14.213081 -8655 2476 6 0 12.163259 12.537713 19.532478 -8656 2476 4 0 12.952113 12.023699 19.336851 -8657 2476 4 0 11.421932 11.885251 19.451751 -8658 2477 6 0 19.216013 1.204159 16.354062 -8659 2477 4 0 19.693651 0.628292 16.987922 -8660 2477 4 0 19.788924 1.982359 16.259421 -8661 2478 6 0 9.476954 16.143883 -14.222672 -8662 2478 4 0 9.874109 15.966920 -15.122506 -8663 2478 4 0 9.278436 15.281894 -13.908079 -8664 2479 6 0 -14.534233 -15.722743 -17.125213 -8665 2479 4 0 -14.612818 -15.234699 -16.271855 -8666 2479 4 0 -14.914996 -15.225762 -17.899753 -8667 2480 6 0 -7.315791 17.649326 18.027047 -8668 2480 4 0 -6.781097 18.032306 18.752166 -8669 2480 4 0 -8.151176 18.220094 17.921736 -8670 2481 6 0 -18.382710 -16.629801 4.193883 -8671 2481 4 0 -18.385951 -16.521263 5.149432 -8672 2481 4 0 -17.627253 -16.147937 3.769420 -8673 2482 6 0 -15.417927 -6.534956 -12.241821 -8674 2482 4 0 -15.990818 -7.277530 -12.157190 -8675 2482 4 0 -15.651097 -5.969923 -11.493776 -8676 2483 6 0 0.402862 14.629930 13.340607 -8677 2483 4 0 -0.252964 15.247709 13.638832 -8678 2483 4 0 0.540834 14.019125 14.040061 -8679 2484 6 0 12.212673 -14.561562 8.432466 -8680 2484 4 0 12.964986 -15.158798 8.469829 -8681 2484 4 0 12.315635 -13.749340 8.974910 -8682 2485 6 0 -18.091351 14.816669 -20.791191 -8683 2485 4 0 -17.950349 14.394028 -19.955312 -8684 2485 4 0 -17.259160 15.337091 -20.997461 -8685 2486 6 0 20.846407 4.941141 -20.805564 -8686 2486 4 0 20.364445 5.609240 -20.314152 -8687 2486 4 0 21.773006 5.036677 -20.468448 -8688 2487 6 0 -18.235581 1.799447 7.616936 -8689 2487 4 0 -18.663035 2.668602 7.871183 -8690 2487 4 0 -18.147248 1.507995 8.534548 -8691 2488 6 0 12.243946 -10.407747 -4.453069 -8692 2488 4 0 12.758610 -10.750408 -5.173538 -8693 2488 4 0 11.391861 -10.887258 -4.514732 -8694 2489 6 0 -15.999205 -0.324038 16.881023 -8695 2489 4 0 -15.685432 -0.202706 15.976630 -8696 2489 4 0 -15.623326 0.405687 17.366937 -8697 2490 6 0 -23.099614 -14.642217 -19.649766 -8698 2490 4 0 -23.777759 -15.309775 -19.518530 -8699 2490 4 0 -23.241127 -14.411915 -20.620505 -8700 2491 6 0 -12.249488 9.185541 -16.320990 -8701 2491 4 0 -12.902804 8.826914 -16.950148 -8702 2491 4 0 -11.588894 9.548457 -16.894605 -8703 2492 6 0 -4.051701 -13.736377 -16.555628 -8704 2492 4 0 -4.494654 -14.354729 -17.129699 -8705 2492 4 0 -4.462835 -13.910768 -15.684946 -8706 2493 6 0 -11.801200 19.657830 -10.999540 -8707 2493 4 0 -10.902720 19.828996 -11.011831 -8708 2493 4 0 -12.193533 20.466103 -10.567549 -8709 2494 6 0 -24.325618 14.045672 -1.110263 -8710 2494 4 0 -24.668600 14.350444 -0.200830 -8711 2494 4 0 -24.816092 13.231043 -1.195474 -8712 2495 6 0 20.913056 15.489658 -18.886527 -8713 2495 4 0 20.368015 16.190531 -18.479805 -8714 2495 4 0 21.821778 15.751011 -18.640831 -8715 2496 6 0 -20.772862 0.764056 -6.084683 -8716 2496 4 0 -20.333324 1.468628 -5.568275 -8717 2496 4 0 -20.870557 -0.044044 -5.434493 -8718 2497 6 0 -16.073764 -5.000219 -5.989733 -8719 2497 4 0 -15.211568 -4.748827 -5.581555 -8720 2497 4 0 -16.376788 -5.851245 -5.640415 -8721 2498 6 0 -9.856355 -16.695376 -19.135619 -8722 2498 4 0 -10.833867 -16.815665 -19.193496 -8723 2498 4 0 -9.591699 -17.153724 -19.905312 -8724 2499 6 0 -14.392982 0.813400 -5.967904 -8725 2499 4 0 -14.439076 -0.104057 -5.900368 -8726 2499 4 0 -15.047260 1.134714 -6.628678 -8727 2500 6 0 11.045455 -13.563452 -6.886523 -8728 2500 4 0 10.981894 -14.173292 -6.136333 -8729 2500 4 0 10.392197 -12.867802 -6.742279 -8730 2501 6 0 20.205100 13.593403 -6.053417 -8731 2501 4 0 19.481313 14.001651 -6.432278 -8732 2501 4 0 20.986779 14.039356 -6.342708 -8733 2502 6 0 -15.365488 5.137757 1.769971 -8734 2502 4 0 -16.164843 4.770892 1.413857 -8735 2502 4 0 -14.688240 4.932112 1.136328 -8736 2503 6 0 -24.720205 -11.036422 -9.472540 -8737 2503 4 0 -25.299911 -10.766165 -8.734947 -8738 2503 4 0 -25.200381 -11.736926 -9.906125 -8739 2504 6 0 14.559792 11.008849 -19.039727 -8740 2504 4 0 15.234376 11.619514 -18.598604 -8741 2504 4 0 13.848001 10.777673 -18.398174 -8742 2505 6 0 20.737940 13.944347 3.008812 -8743 2505 4 0 19.926090 13.665780 2.507060 -8744 2505 4 0 20.524403 14.681916 3.550067 -8745 2506 6 0 -13.687080 4.284684 12.620334 -8746 2506 4 0 -14.374801 3.638577 12.764178 -8747 2506 4 0 -13.341649 4.114854 11.765071 -8748 2507 6 0 10.858099 -17.177182 -20.193932 -8749 2507 4 0 10.006770 -17.050221 -20.711055 -8750 2507 4 0 11.163899 -17.997677 -20.596267 -8751 2508 6 0 -1.413844 20.882523 -7.532723 -8752 2508 4 0 -0.481522 20.795022 -7.591494 -8753 2508 4 0 -1.734791 20.061230 -7.123891 -8754 2509 6 0 14.883760 4.844985 -11.460983 -8755 2509 4 0 14.857826 5.007527 -12.430076 -8756 2509 4 0 14.543696 3.941245 -11.329620 -8757 2510 6 0 -6.076326 -4.794057 13.123230 -8758 2510 4 0 -7.063204 -4.795068 13.194896 -8759 2510 4 0 -5.787599 -5.455376 13.703743 -8760 2511 6 0 26.801734 19.306820 7.537896 -8761 2511 4 0 27.324481 18.524252 7.345834 -8762 2511 4 0 27.305309 20.057747 7.249205 -8763 2512 6 0 17.631040 11.938297 -2.819567 -8764 2512 4 0 18.494147 11.630708 -2.989743 -8765 2512 4 0 17.500906 12.097849 -1.861896 -8766 2513 6 0 -5.066723 14.593124 8.613540 -8767 2513 4 0 -5.776044 13.928470 8.604036 -8768 2513 4 0 -5.472521 15.379622 8.936421 -8769 2514 6 0 -22.625793 -6.943329 -10.402222 -8770 2514 4 0 -22.918006 -7.487802 -11.106371 -8771 2514 4 0 -22.525718 -6.063678 -10.788262 -8772 2515 6 0 11.828624 -19.683428 -20.603919 -8773 2515 4 0 12.217112 -20.243126 -21.346224 -8774 2515 4 0 12.385880 -19.784195 -19.860322 -8775 2516 6 0 -21.139138 9.961065 13.641562 -8776 2516 4 0 -21.977740 9.505083 13.402813 -8777 2516 4 0 -20.669934 9.781538 12.788303 -8778 2517 6 0 25.519216 -5.515401 1.511029 -8779 2517 4 0 26.084211 -5.177738 0.810141 -8780 2517 4 0 24.693318 -5.003524 1.409607 -8781 2518 6 0 26.272080 10.541058 9.764091 -8782 2518 4 0 25.609606 11.193003 9.426754 -8783 2518 4 0 25.839012 9.942262 10.435364 -8784 2519 6 0 25.016001 0.794303 -1.014649 -8785 2519 4 0 25.368203 0.342397 -1.801633 -8786 2519 4 0 25.407512 1.692440 -0.976171 -8787 2520 6 0 -8.746565 3.936264 -17.089748 -8788 2520 4 0 -8.606611 4.042084 -18.035704 -8789 2520 4 0 -8.750589 2.966468 -16.991948 -8790 2521 6 0 21.588920 13.603723 -12.704304 -8791 2521 4 0 21.601929 14.305164 -12.022119 -8792 2521 4 0 21.312576 14.081953 -13.484692 -8793 2522 6 0 -18.216349 -3.529717 0.360926 -8794 2522 4 0 -18.540051 -2.874458 0.978203 -8795 2522 4 0 -18.963370 -4.161327 0.221890 -8796 2523 6 0 19.308604 17.633776 -17.848331 -8797 2523 4 0 18.426310 17.372206 -17.746813 -8798 2523 4 0 19.313729 18.351135 -18.545042 -8799 2524 6 0 23.180289 12.694539 3.506974 -8800 2524 4 0 22.252060 12.962086 3.303073 -8801 2524 4 0 23.366253 11.863114 3.057800 -8802 2525 6 0 -17.100932 8.883526 -6.444854 -8803 2525 4 0 -16.173403 8.831265 -6.716554 -8804 2525 4 0 -17.583234 8.325208 -7.157965 -8805 2526 6 0 14.323717 15.125299 -5.725594 -8806 2526 4 0 15.041767 15.729064 -5.519842 -8807 2526 4 0 13.765048 15.154023 -4.972067 -8808 2527 6 0 -19.909899 0.941274 -8.892043 -8809 2527 4 0 -20.063118 1.882998 -8.670527 -8810 2527 4 0 -20.016683 0.615676 -7.987400 -8811 2528 6 0 -4.062922 0.518298 17.993285 -8812 2528 4 0 -4.234902 1.391334 17.589117 -8813 2528 4 0 -4.820041 -0.077704 17.801729 -8814 2529 6 0 26.232840 -11.346405 0.934374 -8815 2529 4 0 26.965729 -10.796137 1.273638 -8816 2529 4 0 26.535197 -11.828470 0.207089 -8817 2530 6 0 18.568052 -3.606897 4.561302 -8818 2530 4 0 17.633584 -3.536757 4.401867 -8819 2530 4 0 18.956111 -3.197861 3.755933 -8820 2531 6 0 -23.855092 5.074567 4.116598 -8821 2531 4 0 -23.064224 4.611628 4.537652 -8822 2531 4 0 -23.710838 5.025654 3.139103 -8823 2532 6 0 26.437758 -20.018004 1.491909 -8824 2532 4 0 26.350439 -19.182255 1.070486 -8825 2532 4 0 27.361760 -20.307715 1.508970 -8826 2533 6 0 -15.774583 11.702587 -19.124466 -8827 2533 4 0 -15.128134 11.654611 -18.394652 -8828 2533 4 0 -16.197784 10.854994 -19.059229 -8829 2534 6 0 13.604852 -5.588538 -11.240265 -8830 2534 4 0 13.941716 -4.779794 -10.783187 -8831 2534 4 0 13.492173 -6.306084 -10.658525 -8832 2535 6 0 -4.406927 9.867817 9.346751 -8833 2535 4 0 -5.311013 9.555296 9.655422 -8834 2535 4 0 -4.255731 10.665634 9.843775 -8835 2536 6 0 -5.324087 -1.607821 -19.326145 -8836 2536 4 0 -5.081210 -2.540467 -19.512431 -8837 2536 4 0 -5.681118 -1.658898 -18.424650 -8838 2537 6 0 7.210255 -0.591966 -13.016339 -8839 2537 4 0 7.132769 -0.267418 -12.059025 -8840 2537 4 0 7.145986 0.215754 -13.558300 -8841 2538 6 0 13.031739 18.007964 -16.574884 -8842 2538 4 0 13.701983 18.076453 -17.280260 -8843 2538 4 0 13.560834 18.505150 -15.807835 -8844 2539 6 0 -4.939182 19.582248 2.433779 -8845 2539 4 0 -4.348475 19.232076 1.705221 -8846 2539 4 0 -4.493649 20.306827 2.886563 -8847 2540 6 0 -26.648293 -0.947736 -17.385316 -8848 2540 4 0 -26.109245 -1.287067 -18.123131 -8849 2540 4 0 -27.139044 -0.227784 -17.739830 -8850 2541 6 0 19.417331 5.365442 -12.381828 -8851 2541 4 0 20.057565 6.030330 -12.629842 -8852 2541 4 0 18.801680 5.841907 -11.794057 -8853 2542 6 0 -19.679332 -1.764604 -19.638774 -8854 2542 4 0 -19.289416 -1.940059 -18.795824 -8855 2542 4 0 -19.719754 -0.802184 -19.615952 -8856 2543 6 0 16.188925 -8.137607 9.745803 -8857 2543 4 0 15.895930 -8.655747 9.012990 -8858 2543 4 0 15.671496 -7.334126 9.820282 -8859 2544 6 0 17.367529 -1.265528 20.226689 -8860 2544 4 0 17.209414 -2.128384 20.612209 -8861 2544 4 0 17.475811 -0.580216 20.915152 -8862 2545 6 0 20.517093 9.728672 9.587262 -8863 2545 4 0 21.222551 9.963620 10.212987 -8864 2545 4 0 19.824767 9.384636 10.113042 -8865 2546 6 0 -7.547448 20.192218 -20.533482 -8866 2546 4 0 -6.695025 19.629425 -20.571646 -8867 2546 4 0 -8.008402 20.075383 -21.344144 -8868 2547 6 0 -16.582915 -1.120027 -4.095394 -8869 2547 4 0 -16.849559 -0.208322 -4.049542 -8870 2547 4 0 -16.720426 -1.473779 -3.214581 -8871 2548 6 0 4.785781 1.946407 13.103817 -8872 2548 4 0 4.799308 1.247503 12.424632 -8873 2548 4 0 4.583242 1.575294 13.963927 -8874 2549 6 0 -8.165114 -12.900949 2.168446 -8875 2549 4 0 -8.256829 -12.788477 3.143987 -8876 2549 4 0 -7.320909 -13.341131 2.150781 -8877 2550 6 0 -17.554071 -15.744741 -16.262189 -8878 2550 4 0 -17.806278 -16.375423 -15.592159 -8879 2550 4 0 -18.351583 -15.356631 -16.607464 -8880 2551 6 0 27.326866 4.195826 19.441977 -8881 2551 4 0 28.011431 4.581461 18.842795 -8882 2551 4 0 26.527694 4.615286 19.081611 -8883 2552 6 0 -25.419970 -6.739402 -9.247054 -8884 2552 4 0 -25.459364 -7.498417 -9.890859 -8885 2552 4 0 -24.515740 -6.409622 -9.324420 -8886 2553 6 0 -3.380308 -14.523714 -7.300867 -8887 2553 4 0 -3.061003 -15.308131 -6.909980 -8888 2553 4 0 -2.917512 -14.327994 -8.109098 -8889 2554 6 0 26.207829 15.728093 -19.215945 -8890 2554 4 0 25.966653 16.561497 -19.590938 -8891 2554 4 0 26.062905 14.999376 -19.810656 -8892 2555 6 0 -18.866057 -0.711382 15.470718 -8893 2555 4 0 -19.290122 -1.568096 15.298654 -8894 2555 4 0 -17.951441 -0.972639 15.451259 -8895 2556 6 0 18.465047 8.813449 11.216472 -8896 2556 4 0 18.798663 8.151346 11.818158 -8897 2556 4 0 17.716063 8.381682 10.839333 -8898 2557 6 0 -24.781204 -20.600352 -18.705084 -8899 2557 4 0 -25.022898 -19.710672 -18.985244 -8900 2557 4 0 -25.460136 -21.155945 -19.120654 -8901 2558 6 0 22.729959 2.205214 -7.072615 -8902 2558 4 0 22.357169 1.293535 -7.021078 -8903 2558 4 0 22.701750 2.488699 -7.961356 -8904 2559 6 0 12.690918 2.750591 12.342202 -8905 2559 4 0 12.532985 3.617962 11.878555 -8906 2559 4 0 13.133585 2.199071 11.681589 -8907 2560 6 0 24.106980 -11.846114 14.571893 -8908 2560 4 0 23.699036 -11.148912 15.134462 -8909 2560 4 0 23.233694 -12.194399 14.228632 -8910 2561 6 0 0.015177 -14.005197 -19.056743 -8911 2561 4 0 -0.340775 -13.532157 -18.287023 -8912 2561 4 0 -0.773966 -14.258584 -19.587550 -8913 2562 6 0 12.361724 4.484402 -15.999210 -8914 2562 4 0 12.200963 5.407914 -16.093788 -8915 2562 4 0 11.619804 4.000673 -15.643034 -8916 2563 6 0 -4.332154 14.465183 5.913532 -8917 2563 4 0 -3.550293 15.013973 5.769350 -8918 2563 4 0 -4.511279 14.482735 6.928514 -8919 2564 6 0 -2.423184 -19.036991 20.142811 -8920 2564 4 0 -2.033960 -18.570661 20.871778 -8921 2564 4 0 -2.200093 -18.567230 19.324641 -8922 2565 6 0 -11.400807 16.524027 12.877501 -8923 2565 4 0 -10.684181 16.008719 12.380621 -8924 2565 4 0 -12.191788 16.488834 12.343702 -8925 2566 6 0 15.966093 16.748739 -1.323378 -8926 2566 4 0 16.412638 17.338758 -1.989326 -8927 2566 4 0 15.598457 17.376590 -0.651299 -8928 2567 6 0 23.415752 18.871243 -18.062665 -8929 2567 4 0 23.451778 19.269195 -17.182012 -8930 2567 4 0 22.494121 18.975734 -18.366439 -8931 2568 6 0 -8.572201 3.275476 -10.014766 -8932 2568 4 0 -9.403406 3.269988 -10.503336 -8933 2568 4 0 -8.724278 3.329701 -9.074127 -8934 2569 6 0 -11.585480 -0.851627 12.287499 -8935 2569 4 0 -11.320746 -0.082366 12.769641 -8936 2569 4 0 -11.472816 -0.637183 11.362553 -8937 2570 6 0 7.497602 -9.434427 -12.321588 -8938 2570 4 0 8.071421 -10.126251 -12.076632 -8939 2570 4 0 8.042121 -8.593371 -12.397957 -8940 2571 6 0 4.778213 -10.266015 -19.410251 -8941 2571 4 0 5.274109 -9.668837 -18.817242 -8942 2571 4 0 4.120565 -9.651627 -19.758229 -8943 2572 6 0 -6.111007 -15.043780 2.679188 -8944 2572 4 0 -5.289890 -15.200515 3.239461 -8945 2572 4 0 -6.645239 -15.919834 2.758924 -8946 2573 6 0 -19.627428 -18.648983 -20.285776 -8947 2573 4 0 -18.763886 -19.012576 -20.099994 -8948 2573 4 0 -19.447444 -17.996380 -20.946059 -8949 2574 6 0 9.799336 -4.134177 -14.605227 -8950 2574 4 0 9.726430 -3.298650 -14.107003 -8951 2574 4 0 10.588497 -4.491055 -14.189406 -8952 2575 6 0 6.956853 10.981174 -15.927933 -8953 2575 4 0 6.333575 10.252829 -16.183246 -8954 2575 4 0 7.290948 10.697439 -15.077221 -8955 2576 6 0 15.996505 -7.421222 -2.982722 -8956 2576 4 0 16.037378 -8.363657 -3.163947 -8957 2576 4 0 15.971488 -7.414229 -2.004616 -8958 2577 6 0 24.116659 17.319712 -5.748450 -8959 2577 4 0 24.717303 17.575301 -5.045222 -8960 2577 4 0 24.154648 16.310133 -5.689457 -8961 2578 6 0 -25.014350 19.047244 5.636389 -8962 2578 4 0 -24.831592 18.532801 6.467994 -8963 2578 4 0 -25.569417 19.791621 5.840508 -8964 2579 6 0 -13.760710 14.201790 -16.036971 -8965 2579 4 0 -13.882187 15.099458 -16.440666 -8966 2579 4 0 -13.724599 14.326841 -15.088458 -8967 2580 6 0 -24.389392 17.787413 -4.553817 -8968 2580 4 0 -24.972675 18.418071 -5.068364 -8969 2580 4 0 -24.356964 18.276421 -3.698179 -8970 2581 6 0 -18.723840 -6.150098 -13.057313 -8971 2581 4 0 -18.318192 -6.956567 -12.670367 -8972 2581 4 0 -17.968230 -5.629913 -13.262178 -8973 2582 6 0 0.195836 -4.045493 20.385139 -8974 2582 4 0 0.549498 -4.632208 21.063706 -8975 2582 4 0 -0.603773 -4.486592 20.007533 -8976 2583 6 0 -5.473498 -2.320372 -16.638624 -8977 2583 4 0 -5.812762 -2.143253 -15.717531 -8978 2583 4 0 -5.163919 -3.274843 -16.629360 -8979 2584 6 0 21.657434 10.195244 -12.556194 -8980 2584 4 0 21.466450 11.110479 -12.686972 -8981 2584 4 0 21.662028 10.206355 -11.604800 -8982 2585 6 0 -18.526380 -11.853303 0.119709 -8983 2585 4 0 -18.677742 -12.441590 -0.589422 -8984 2585 4 0 -18.075660 -11.001968 -0.204346 -8985 2586 6 0 -19.755563 -18.537381 -2.766741 -8986 2586 4 0 -19.962233 -18.408807 -3.703137 -8987 2586 4 0 -19.999131 -17.782990 -2.372006 -8988 2587 6 0 25.476128 17.625846 -3.184333 -8989 2587 4 0 26.203145 17.076934 -2.886644 -8990 2587 4 0 25.710710 18.493253 -2.850200 -8991 2588 6 0 -22.305377 1.710018 15.373391 -8992 2588 4 0 -22.044667 1.930929 16.308564 -8993 2588 4 0 -22.836038 0.853232 15.392466 -8994 2589 6 0 2.757401 -15.671844 -1.738405 -8995 2589 4 0 2.387180 -15.115097 -1.096143 -8996 2589 4 0 3.413578 -16.267070 -1.380191 -8997 2590 6 0 25.430670 -2.334847 6.648866 -8998 2590 4 0 25.893201 -2.829135 7.309607 -8999 2590 4 0 24.545839 -2.463509 7.030661 -9000 2591 6 0 3.889750 2.458553 -20.722084 -9001 2591 4 0 3.444777 1.541092 -20.936428 -9002 2591 4 0 3.192280 2.998470 -20.481554 -9003 2592 6 0 19.435277 -5.919201 6.178342 -9004 2592 4 0 18.742497 -6.147165 6.835144 -9005 2592 4 0 19.082846 -5.397301 5.451949 -9006 2593 6 0 -1.325956 10.838557 -7.120140 -9007 2593 4 0 -1.379491 10.683558 -6.153949 -9008 2593 4 0 -1.024828 11.727198 -7.077078 -9009 2594 6 0 -3.710126 14.086716 -7.244913 -9010 2594 4 0 -4.337761 13.541137 -7.799347 -9011 2594 4 0 -4.000550 13.881396 -6.362053 -9012 2595 6 0 14.433778 -1.890208 -13.881242 -9013 2595 4 0 13.768753 -2.557931 -14.088173 -9014 2595 4 0 14.194801 -1.387777 -13.039639 -9015 2596 6 0 -18.934813 -1.053060 1.293190 -9016 2596 4 0 -19.547923 -0.821685 1.967866 -9017 2596 4 0 -18.094001 -0.641682 1.660883 -9018 2597 6 0 -22.405398 -20.039410 9.627718 -9019 2597 4 0 -22.796434 -20.600182 8.972850 -9020 2597 4 0 -22.131968 -19.299630 9.083235 -9021 2598 6 0 -1.229753 11.457428 10.074790 -9022 2598 4 0 -0.334237 11.703470 10.327241 -9023 2598 4 0 -1.157156 10.837370 9.316439 -9024 2599 6 0 25.443002 2.066902 -6.888756 -9025 2599 4 0 25.641541 2.915762 -7.359788 -9026 2599 4 0 24.465208 2.093523 -6.739748 -9027 2600 6 0 -16.581214 16.377510 -14.832297 -9028 2600 4 0 -16.587099 15.904994 -13.968869 -9029 2600 4 0 -16.866698 17.278853 -14.742235 -9030 2601 6 0 11.983368 11.828299 -3.823724 -9031 2601 4 0 12.336985 12.445002 -3.178218 -9032 2601 4 0 11.049304 11.604866 -3.665958 -9033 2602 6 0 21.164572 -1.185333 -16.015117 -9034 2602 4 0 20.715162 -0.431609 -16.354646 -9035 2602 4 0 20.819380 -1.264906 -15.151962 -9036 2603 6 0 5.457366 -10.657358 -13.800772 -9037 2603 4 0 4.779858 -10.165440 -14.279853 -9038 2603 4 0 6.212045 -10.040539 -13.706945 -9039 2604 6 0 -16.423429 10.434483 -15.277807 -9040 2604 4 0 -15.708526 10.928082 -15.699592 -9041 2604 4 0 -15.960741 9.897443 -14.616298 -9042 2605 6 0 -20.419587 -19.665938 5.773644 -9043 2605 4 0 -21.363895 -19.581010 6.013361 -9044 2605 4 0 -19.853905 -19.280863 6.468747 -9045 2606 6 0 19.508036 -18.494331 8.912926 -9046 2606 4 0 19.727428 -18.712582 9.835185 -9047 2606 4 0 19.913134 -19.105692 8.298087 -9048 2607 6 0 19.742354 -2.749373 18.946243 -9049 2607 4 0 20.356111 -2.867791 19.687152 -9050 2607 4 0 19.073759 -2.160527 19.341368 -9051 2608 6 0 19.005725 16.659102 -4.024674 -9052 2608 4 0 18.186097 16.480938 -4.427734 -9053 2608 4 0 18.814608 17.298422 -3.358553 -9054 2609 6 0 -8.835887 18.312505 -7.442487 -9055 2609 4 0 -8.830492 17.732483 -8.193218 -9056 2609 4 0 -9.752425 18.649905 -7.404203 -9057 2610 6 0 -17.336326 4.931650 10.634975 -9058 2610 4 0 -16.450097 5.217439 10.271982 -9059 2610 4 0 -17.882557 4.558518 9.889708 -9060 2611 6 0 -3.010824 -5.905956 6.847801 -9061 2611 4 0 -2.748688 -5.113745 6.359917 -9062 2611 4 0 -2.163371 -6.028171 7.336259 -9063 2612 6 0 26.674110 12.326845 1.003397 -9064 2612 4 0 26.498840 12.357411 1.941376 -9065 2612 4 0 26.095376 11.585032 0.663483 -9066 2613 6 0 -3.647702 -6.137587 13.529843 -9067 2613 4 0 -3.585661 -5.496886 12.804045 -9068 2613 4 0 -3.582668 -6.993279 13.154224 -9069 2614 6 0 1.988731 3.642853 -17.323133 -9070 2614 4 0 1.657523 3.030179 -16.746788 -9071 2614 4 0 1.714357 4.548463 -17.022125 -9072 2615 6 0 -21.467906 15.279507 16.450567 -9073 2615 4 0 -21.342432 15.396388 15.459294 -9074 2615 4 0 -21.255917 16.108495 16.873553 -9075 2616 6 0 10.722659 -15.332451 -4.565762 -9076 2616 4 0 10.219128 -14.832093 -3.873147 -9077 2616 4 0 11.478425 -15.649236 -4.183169 -9078 2617 6 0 -15.362943 8.381189 -9.911049 -9079 2617 4 0 -15.790421 8.852870 -9.163602 -9080 2617 4 0 -15.901457 8.456340 -10.687883 -9081 2618 6 0 -6.117005 -17.666075 11.598739 -9082 2618 4 0 -5.807530 -18.593273 11.402299 -9083 2618 4 0 -5.391363 -17.258909 12.082625 -9084 2619 6 0 15.809786 8.519937 -19.377408 -9085 2619 4 0 15.758815 8.522648 -20.341707 -9086 2619 4 0 15.420577 9.368007 -19.123689 -9087 2620 6 0 16.939240 -18.373645 7.950825 -9088 2620 4 0 17.207858 -18.006941 7.092997 -9089 2620 4 0 17.812610 -18.447723 8.295733 -9090 2621 6 0 -12.507522 -15.054493 6.331021 -9091 2621 4 0 -13.226017 -14.420799 6.460827 -9092 2621 4 0 -11.849976 -14.561229 5.786593 -9093 2622 6 0 -18.182152 4.799952 -11.866172 -9094 2622 4 0 -18.038039 4.897463 -10.917789 -9095 2622 4 0 -18.695958 4.021311 -12.029165 -9096 2623 6 0 -9.377203 11.614184 3.311631 -9097 2623 4 0 -9.092786 10.701027 3.311174 -9098 2623 4 0 -8.739940 12.083447 3.909937 -9099 2624 6 0 24.894256 -5.525807 -20.636863 -9100 2624 4 0 24.507335 -5.547278 -19.753182 -9101 2624 4 0 25.790020 -5.247577 -20.418409 -9102 2625 6 0 -23.172834 -17.188227 2.440789 -9103 2625 4 0 -23.395171 -18.018880 2.825747 -9104 2625 4 0 -22.193387 -17.125237 2.517058 -9105 2626 6 0 24.135008 -19.930490 -4.684991 -9106 2626 4 0 24.122289 -18.925946 -4.803857 -9107 2626 4 0 24.712920 -20.215229 -5.372877 -9108 2627 6 0 -17.792076 11.534192 15.059996 -9109 2627 4 0 -16.965370 11.797213 15.470927 -9110 2627 4 0 -18.560988 11.913780 15.443831 -9111 2628 6 0 -18.514941 20.339905 -0.125520 -9112 2628 4 0 -18.667243 19.462095 -0.535183 -9113 2628 4 0 -18.065408 20.873029 -0.719025 -9114 2629 6 0 -22.940337 -3.988570 -9.248839 -9115 2629 4 0 -22.556330 -3.193733 -8.929657 -9116 2629 4 0 -23.624559 -3.640649 -9.848732 -9117 2630 6 0 12.039511 -1.981999 -19.397718 -9118 2630 4 0 12.283853 -1.068627 -19.717430 -9119 2630 4 0 11.293173 -1.821725 -18.743785 -9120 2631 6 0 26.340624 1.335259 19.289276 -9121 2631 4 0 26.841055 0.655996 19.819897 -9122 2631 4 0 26.800288 2.181296 19.386054 -9123 2632 6 0 5.916695 14.316365 5.690974 -9124 2632 4 0 6.301016 14.102416 4.790199 -9125 2632 4 0 5.065517 13.849361 5.701154 -9126 2633 6 0 13.370348 -18.821001 19.162682 -9127 2633 4 0 14.108633 -19.097802 18.663220 -9128 2633 4 0 13.699085 -18.168012 19.800526 -9129 2634 6 0 23.405805 15.068779 9.736213 -9130 2634 4 0 22.573160 14.660972 10.019951 -9131 2634 4 0 23.219623 15.734719 9.058682 -9132 2635 6 0 -5.408829 13.828838 18.447419 -9133 2635 4 0 -6.168561 13.481395 17.992340 -9134 2635 4 0 -4.784831 14.172206 17.836655 -9135 2636 6 0 -13.245623 5.670961 -0.018513 -9136 2636 4 0 -12.419620 5.936404 0.475256 -9137 2636 4 0 -12.953928 4.989305 -0.645525 -9138 2637 6 0 17.249203 -6.366308 2.555121 -9139 2637 4 0 18.196321 -6.281038 2.412817 -9140 2637 4 0 16.966298 -7.253693 2.384394 -9141 2638 6 0 -5.296416 19.864731 -1.668047 -9142 2638 4 0 -5.749980 19.031441 -1.444019 -9143 2638 4 0 -4.299943 19.722461 -1.604460 -9144 2639 6 0 -16.684535 5.831070 -9.866261 -9145 2639 4 0 -17.133431 6.510584 -9.314798 -9146 2639 4 0 -15.783199 6.112174 -9.905469 -9147 2640 6 0 16.265639 6.852785 -7.896636 -9148 2640 4 0 16.527802 6.700601 -8.808419 -9149 2640 4 0 17.070642 6.577942 -7.414049 -9150 2641 6 0 -21.312105 18.191924 10.459876 -9151 2641 4 0 -20.762633 18.843032 9.983997 -9152 2641 4 0 -20.749711 17.337404 10.555555 -9153 2642 6 0 -16.100357 -8.153697 -5.142815 -9154 2642 4 0 -16.563606 -8.364758 -6.004467 -9155 2642 4 0 -15.154250 -7.906094 -5.382181 -9156 2643 6 0 -9.615286 13.091225 20.211510 -9157 2643 4 0 -9.791366 12.655362 19.395743 -9158 2643 4 0 -10.462726 13.102852 20.699120 -9159 2644 6 0 -18.598056 -9.697384 8.839376 -9160 2644 4 0 -18.669310 -10.516686 9.343906 -9161 2644 4 0 -18.931363 -8.964428 9.385541 -9162 2645 6 0 7.933987 -14.093590 6.186519 -9163 2645 4 0 8.207527 -14.668399 6.884006 -9164 2645 4 0 8.301922 -13.235214 6.418423 -9165 2646 6 0 14.288937 4.874936 -8.228821 -9166 2646 4 0 13.542574 5.155680 -8.863279 -9167 2646 4 0 14.810343 5.654336 -8.058197 -9168 2647 6 0 12.246994 8.643633 9.863872 -9169 2647 4 0 12.726549 8.831956 10.652198 -9170 2647 4 0 11.373287 8.283693 10.003012 -9171 2648 6 0 -25.270711 -9.927997 8.533897 -9172 2648 4 0 -24.762785 -10.112710 9.286810 -9173 2648 4 0 -25.238676 -10.761122 8.058752 -9174 2649 6 0 22.391162 10.881778 -20.435148 -9175 2649 4 0 21.795271 11.117663 -21.128050 -9176 2649 4 0 22.356795 11.558284 -19.773744 -9177 2650 6 0 -0.807548 -14.371789 12.994860 -9178 2650 4 0 0.169556 -14.376294 13.074982 -9179 2650 4 0 -1.104471 -13.660037 12.471373 -9180 2651 6 0 7.732198 13.812736 20.037022 -9181 2651 4 0 8.322105 14.100985 20.697382 -9182 2651 4 0 7.280009 14.639584 19.691732 -9183 2652 6 0 19.803756 0.841082 -17.134900 -9184 2652 4 0 19.288798 0.974936 -16.312323 -9185 2652 4 0 20.344973 1.668924 -17.222026 -9186 2653 6 0 3.006216 10.098697 2.949568 -9187 2653 4 0 2.578021 10.984530 2.806805 -9188 2653 4 0 3.907142 10.297785 3.184074 -9189 2654 6 0 15.873541 13.013460 -17.893320 -9190 2654 4 0 15.039690 13.457379 -17.843027 -9191 2654 4 0 16.307486 13.271147 -17.069099 -9192 2655 6 0 17.084293 4.346353 -14.985379 -9193 2655 4 0 16.897186 4.218804 -15.905422 -9194 2655 4 0 18.061148 4.233803 -14.912436 -9195 2656 6 0 -21.371098 -2.500601 10.634104 -9196 2656 4 0 -21.050859 -3.246995 11.070174 -9197 2656 4 0 -21.156581 -2.501005 9.672558 -9198 2657 6 0 -18.750890 1.105436 13.107103 -9199 2657 4 0 -19.405065 0.422507 13.292755 -9200 2657 4 0 -18.176163 1.261421 13.836264 -9201 2658 6 0 -14.137019 19.297443 5.108564 -9202 2658 4 0 -14.447107 19.586959 4.301598 -9203 2658 4 0 -14.859255 19.041560 5.714699 -9204 2659 6 0 2.347144 -4.353199 10.184512 -9205 2659 4 0 3.047693 -4.789736 10.732160 -9206 2659 4 0 1.864240 -5.020658 9.719618 -9207 2660 6 0 8.101274 -12.868709 15.865572 -9208 2660 4 0 9.008432 -13.290947 15.950755 -9209 2660 4 0 8.164041 -12.117937 16.446599 -9210 2661 6 0 -7.675769 -15.390059 12.539289 -9211 2661 4 0 -7.409496 -14.626553 11.915042 -9212 2661 4 0 -7.614755 -16.191218 12.009248 -9213 2662 6 0 -21.398277 17.515428 0.659811 -9214 2662 4 0 -22.373476 17.461084 0.916402 -9215 2662 4 0 -21.187696 16.555626 0.790839 -9216 2663 6 0 -16.011532 15.600476 -5.525384 -9217 2663 4 0 -15.829552 14.648078 -5.450075 -9218 2663 4 0 -15.676036 15.915857 -6.377072 -9219 2664 6 0 -20.171456 -7.558847 9.362228 -9220 2664 4 0 -19.542732 -6.922489 9.041804 -9221 2664 4 0 -20.565885 -7.210783 10.122068 -9222 2665 6 0 -10.027028 2.569851 14.780708 -9223 2665 4 0 -10.957643 2.497925 14.922514 -9224 2665 4 0 -9.726024 3.392205 15.205842 -9225 2666 6 0 -12.389641 -3.630575 19.832870 -9226 2666 4 0 -12.243221 -2.721357 19.438252 -9227 2666 4 0 -11.816036 -4.199902 19.239521 -9228 2667 6 0 18.688398 -15.142019 -11.646870 -9229 2667 4 0 18.104901 -15.132683 -12.455435 -9230 2667 4 0 19.565818 -14.972254 -11.954461 -9231 2668 6 0 -16.127768 -4.186936 16.465789 -9232 2668 4 0 -16.199826 -5.136635 16.281789 -9233 2668 4 0 -15.213417 -3.948084 16.556706 -9234 2669 6 0 -5.695916 9.820869 12.533783 -9235 2669 4 0 -6.081058 9.297651 11.888045 -9236 2669 4 0 -6.375197 10.194994 13.105807 -9237 2670 6 0 -11.767595 7.371441 19.819990 -9238 2670 4 0 -12.489308 7.774706 20.373473 -9239 2670 4 0 -10.903774 7.497881 20.264329 -9240 2671 6 0 -18.646029 -3.188135 4.429231 -9241 2671 4 0 -18.121897 -2.394969 4.628228 -9242 2671 4 0 -19.564881 -3.024196 4.677418 -9243 2672 6 0 -27.199358 17.790334 15.106308 -9244 2672 4 0 -27.385927 16.881826 14.776421 -9245 2672 4 0 -27.100030 17.729872 16.057267 -9246 2673 6 0 18.093363 3.769702 -4.593442 -9247 2673 4 0 18.609903 3.037301 -4.942422 -9248 2673 4 0 18.650829 4.233336 -3.997439 -9249 2674 6 0 7.706432 11.586595 6.521802 -9250 2674 4 0 7.812472 12.398627 6.995928 -9251 2674 4 0 7.694286 11.737503 5.595545 -9252 2675 6 0 -23.496957 14.349318 18.036220 -9253 2675 4 0 -22.854057 14.699094 17.423607 -9254 2675 4 0 -22.990832 13.822071 18.687726 -9255 2676 6 0 -4.664327 -11.498090 8.919813 -9256 2676 4 0 -5.320061 -11.113845 8.334147 -9257 2676 4 0 -4.917357 -12.403653 9.095316 -9258 2677 6 0 -12.823426 10.100060 12.766547 -9259 2677 4 0 -13.732598 9.891677 12.621183 -9260 2677 4 0 -12.785614 10.926980 13.238539 -9261 2678 6 0 -17.217436 3.102574 -9.344857 -9262 2678 4 0 -16.824523 3.966216 -9.255133 -9263 2678 4 0 -18.161389 3.114177 -9.202666 -9264 2679 6 0 -19.237099 13.102459 19.268997 -9265 2679 4 0 -18.881981 13.843795 19.761617 -9266 2679 4 0 -18.662460 12.340333 19.526666 -9267 2680 6 0 -9.459329 4.127006 -20.423384 -9268 2680 4 0 -9.437953 4.152565 -21.392157 -9269 2680 4 0 -9.259556 3.201676 -20.170944 -9270 2681 6 0 16.881832 1.847629 -10.429065 -9271 2681 4 0 16.137346 2.355903 -10.841218 -9272 2681 4 0 16.970716 2.383474 -9.646384 -9273 2682 6 0 14.087997 4.886317 -18.329611 -9274 2682 4 0 13.870527 5.790902 -18.194453 -9275 2682 4 0 13.733176 4.313827 -17.614840 -9276 2683 6 0 -16.672076 -8.158476 12.371072 -9277 2683 4 0 -16.864374 -8.959184 11.822666 -9278 2683 4 0 -15.812107 -8.255964 12.755980 -9279 2684 6 0 -19.299758 3.045618 -4.235388 -9280 2684 4 0 -19.897059 2.549328 -3.677605 -9281 2684 4 0 -19.150628 3.861874 -3.750292 -9282 2685 6 0 -23.652514 -4.511442 -6.532734 -9283 2685 4 0 -22.727919 -4.287115 -6.467785 -9284 2685 4 0 -23.794359 -4.367125 -7.440392 -9285 2686 6 0 -2.920139 11.742479 14.018818 -9286 2686 4 0 -3.093279 11.094202 13.278761 -9287 2686 4 0 -2.213003 12.387804 13.722639 -9288 2687 6 0 26.349425 3.441434 -0.896655 -9289 2687 4 0 25.559323 3.941367 -0.786766 -9290 2687 4 0 26.827837 3.589174 -1.727789 -9291 2688 6 0 24.371024 -6.950117 11.157076 -9292 2688 4 0 24.363949 -7.335870 12.010991 -9293 2688 4 0 23.997586 -7.623084 10.641501 -9294 2689 6 0 -22.986862 7.597219 -10.685297 -9295 2689 4 0 -22.839220 7.363568 -11.582970 -9296 2689 4 0 -23.377355 8.488181 -10.698170 -9297 2690 6 0 -26.260863 2.606900 0.424694 -9298 2690 4 0 -25.763469 2.340546 -0.362004 -9299 2690 4 0 -27.210163 2.597209 0.142899 -9300 2691 6 0 -12.863331 19.210721 9.863577 -9301 2691 4 0 -12.261758 19.250393 10.674962 -9302 2691 4 0 -13.524604 18.506027 9.993308 -9303 2692 6 0 -21.978336 -14.820148 8.330413 -9304 2692 4 0 -21.114644 -14.929597 7.888749 -9305 2692 4 0 -21.801101 -14.612357 9.239922 -9306 2693 6 0 4.170159 8.312971 19.162038 -9307 2693 4 0 4.570566 7.905151 18.357550 -9308 2693 4 0 3.241810 8.258885 18.904642 -9309 2694 6 0 20.797031 -12.724867 -4.841837 -9310 2694 4 0 20.936034 -13.677427 -4.931553 -9311 2694 4 0 21.567394 -12.221377 -4.833917 -9312 2695 6 0 13.112963 4.999431 10.925314 -9313 2695 4 0 13.381193 5.910915 11.162187 -9314 2695 4 0 12.775168 5.031277 10.023795 -9315 2696 6 0 -17.488498 18.101828 -9.390547 -9316 2696 4 0 -16.811412 18.773847 -9.686587 -9317 2696 4 0 -17.803299 18.410345 -8.511456 -9318 2697 6 0 17.749103 -8.641103 -11.171278 -9319 2697 4 0 17.842099 -7.910400 -11.803229 -9320 2697 4 0 18.554099 -8.647320 -10.650095 -9321 2698 6 0 23.187132 -9.133014 9.904940 -9322 2698 4 0 23.460415 -9.970033 10.292082 -9323 2698 4 0 22.233888 -9.184916 9.742240 -9324 2699 6 0 14.891551 9.368784 -7.655561 -9325 2699 4 0 15.425686 8.571538 -7.734882 -9326 2699 4 0 15.193600 9.946038 -8.368338 -9327 2700 6 0 -23.866954 -2.554397 -3.337520 -9328 2700 4 0 -23.349227 -3.276607 -2.890486 -9329 2700 4 0 -24.593652 -2.997738 -3.796287 -9330 2701 6 0 5.289348 -7.469003 -13.632279 -9331 2701 4 0 5.277377 -6.512734 -13.514077 -9332 2701 4 0 5.158552 -7.590503 -14.588796 -9333 2702 6 0 -24.673900 -20.221091 14.116865 -9334 2702 4 0 -24.507583 -21.124377 14.341508 -9335 2702 4 0 -24.631103 -20.019803 13.186904 -9336 2703 6 0 23.849959 -2.905384 -13.612324 -9337 2703 4 0 23.991560 -2.301635 -14.360144 -9338 2703 4 0 23.035961 -3.322471 -13.648750 -9339 2704 6 0 9.597419 13.539609 16.458855 -9340 2704 4 0 8.786247 13.049602 16.392590 -9341 2704 4 0 9.783350 13.953319 15.588815 -9342 2705 6 0 25.970484 6.179678 15.798539 -9343 2705 4 0 26.018959 6.019011 14.863720 -9344 2705 4 0 26.760326 5.647911 16.135033 -9345 2706 6 0 15.995160 -8.299211 -19.360180 -9346 2706 4 0 16.084534 -7.778026 -20.183460 -9347 2706 4 0 16.045247 -9.240694 -19.615365 -9348 2707 6 0 -14.294639 13.545693 12.129310 -9349 2707 4 0 -14.596139 13.059241 11.355518 -9350 2707 4 0 -13.936091 12.903120 12.762555 -9351 2708 6 0 -19.407809 -1.632719 -10.223791 -9352 2708 4 0 -18.944881 -0.931680 -10.694558 -9353 2708 4 0 -19.337036 -2.518503 -10.649693 -9354 2709 6 0 19.353851 17.575670 17.852735 -9355 2709 4 0 19.970328 18.410638 17.937921 -9356 2709 4 0 18.705869 17.842357 17.182350 -9357 2710 6 0 7.952485 -13.835833 10.779314 -9358 2710 4 0 8.503126 -13.070419 11.090754 -9359 2710 4 0 7.207795 -13.430815 10.322018 -9360 2711 6 0 -22.842698 -2.314944 16.647836 -9361 2711 4 0 -23.333149 -1.519155 16.340397 -9362 2711 4 0 -23.463394 -3.038396 16.463743 -9363 2712 6 0 -19.201717 2.632915 18.127454 -9364 2712 4 0 -20.123441 2.325926 18.179315 -9365 2712 4 0 -19.210821 3.510831 17.811602 -9366 2713 6 0 14.940360 -1.960385 -5.022951 -9367 2713 4 0 15.464903 -2.467492 -5.627366 -9368 2713 4 0 15.028383 -1.068080 -5.249177 -9369 2714 6 0 18.305226 -9.507548 11.469011 -9370 2714 4 0 18.631115 -9.386360 12.404545 -9371 2714 4 0 17.861273 -8.670836 11.223009 -9372 2715 6 0 14.602066 10.381034 5.005010 -9373 2715 4 0 13.693795 10.430464 4.699453 -9374 2715 4 0 14.612959 10.041819 5.921815 -9375 2716 6 0 2.027713 14.335519 -2.737302 -9376 2716 4 0 2.701727 15.041848 -2.820213 -9377 2716 4 0 1.287972 14.760203 -2.236217 -9378 2717 6 0 7.583318 14.155640 -9.444813 -9379 2717 4 0 6.943304 13.664978 -8.934443 -9380 2717 4 0 7.541292 15.069839 -9.060789 -9381 2718 6 0 6.157219 -18.775945 -4.259618 -9382 2718 4 0 6.564876 -17.949995 -4.135465 -9383 2718 4 0 5.381952 -18.685791 -4.858352 -9384 2719 6 0 -17.694760 -19.372982 4.444716 -9385 2719 4 0 -18.482553 -19.775840 4.189782 -9386 2719 4 0 -17.768985 -18.373906 4.216234 -9387 2720 6 0 -7.853241 -10.893164 5.893751 -9388 2720 4 0 -8.018175 -11.113207 6.770281 -9389 2720 4 0 -8.721602 -10.559022 5.533534 -9390 2721 6 0 -0.179053 -16.316262 -6.972426 -9391 2721 4 0 -0.917372 -16.443486 -6.358316 -9392 2721 4 0 0.161491 -15.370029 -6.873414 -9393 2722 6 0 -17.840107 2.077389 4.804516 -9394 2722 4 0 -18.321956 2.898522 4.546830 -9395 2722 4 0 -17.883766 1.968309 5.738130 -9396 2723 6 0 22.514225 -13.301014 8.910658 -9397 2723 4 0 22.980267 -13.555893 9.738284 -9398 2723 4 0 22.816838 -13.961875 8.319245 -9399 2724 6 0 8.642838 -14.756688 -17.347259 -9400 2724 4 0 7.685639 -14.854800 -17.271066 -9401 2724 4 0 9.104821 -15.542415 -17.427483 -9402 2725 6 0 1.148414 -18.182410 2.438452 -9403 2725 4 0 1.244513 -18.018729 1.471145 -9404 2725 4 0 0.297784 -18.622295 2.484621 -9405 2726 6 0 -0.615129 -11.682105 -14.874888 -9406 2726 4 0 -0.743014 -12.466140 -15.424873 -9407 2726 4 0 -0.401037 -10.992229 -15.542345 -9408 2727 6 0 0.382292 8.435158 -17.928055 -9409 2727 4 0 1.324448 8.603691 -17.753474 -9410 2727 4 0 -0.034745 8.730008 -17.117939 -9411 2728 6 0 16.913096 -13.325161 -8.541691 -9412 2728 4 0 17.365381 -13.123665 -7.714485 -9413 2728 4 0 17.395114 -14.047333 -9.044404 -9414 2729 6 0 -21.295513 -11.021940 0.140848 -9415 2729 4 0 -20.399742 -11.414489 0.196618 -9416 2729 4 0 -21.717453 -11.457849 -0.596997 -9417 2730 6 0 16.257153 -20.396691 -7.748186 -9418 2730 4 0 15.866593 -21.141436 -8.252209 -9419 2730 4 0 16.774217 -20.799101 -7.019481 -9420 2731 6 0 0.208862 17.804049 -6.156398 -9421 2731 4 0 -0.761445 17.806961 -6.377662 -9422 2731 4 0 0.362977 16.942869 -5.716103 -9423 2732 6 0 16.820504 12.298715 0.018055 -9424 2732 4 0 17.269628 12.806166 0.753963 -9425 2732 4 0 16.616966 11.447779 0.422257 -9426 2733 6 0 8.249689 9.539413 -5.657026 -9427 2733 4 0 7.926267 8.961633 -4.961649 -9428 2733 4 0 7.466873 9.988595 -6.079963 -9429 2734 6 0 -6.420145 -15.194726 -2.072771 -9430 2734 4 0 -6.645150 -15.017421 -2.971457 -9431 2734 4 0 -5.532921 -14.874756 -2.025757 -9432 2735 6 0 -19.505572 1.070481 -18.793079 -9433 2735 4 0 -18.974247 1.767142 -19.229226 -9434 2735 4 0 -19.357244 1.271413 -17.799689 -9435 2736 6 0 20.278433 -11.278541 19.375197 -9436 2736 4 0 20.311617 -10.856797 20.258994 -9437 2736 4 0 20.934421 -12.034086 19.419062 -9438 2737 6 0 -10.619435 15.949865 1.585511 -9439 2737 4 0 -10.621509 15.567618 2.491670 -9440 2737 4 0 -10.362619 16.916267 1.609401 -9441 2738 6 0 -1.101917 -7.441924 10.586362 -9442 2738 4 0 -0.567999 -7.634893 11.314871 -9443 2738 4 0 -0.711206 -6.670438 10.158382 -9444 2739 6 0 -8.851165 -9.058377 -8.388886 -9445 2739 4 0 -9.044805 -8.277288 -8.905613 -9446 2739 4 0 -7.947771 -9.334823 -8.625881 -9447 2740 6 0 -12.865173 -20.003868 -17.685004 -9448 2740 4 0 -11.900331 -20.290871 -17.648188 -9449 2740 4 0 -13.259242 -20.215643 -16.805809 -9450 2741 6 0 8.134636 3.904853 11.647104 -9451 2741 4 0 7.339621 4.198944 12.086138 -9452 2741 4 0 8.359181 3.015108 11.941173 -9453 2742 6 0 19.642179 -0.232387 9.832126 -9454 2742 4 0 18.865134 -0.769467 9.662648 -9455 2742 4 0 19.348750 0.264237 10.621214 -9456 2743 6 0 -12.682747 8.424040 -10.230134 -9457 2743 4 0 -13.551445 8.389330 -9.854912 -9458 2743 4 0 -12.463391 9.379389 -10.339605 -9459 2744 6 0 26.914440 16.154997 -16.554272 -9460 2744 4 0 26.893167 15.808906 -17.482437 -9461 2744 4 0 26.594368 15.442541 -16.021243 -9462 2745 6 0 -6.756073 6.486074 12.621266 -9463 2745 4 0 -6.001614 6.299854 12.037502 -9464 2745 4 0 -7.537856 6.154367 12.136267 -9465 2746 6 0 -1.534934 -0.378729 -11.255488 -9466 2746 4 0 -1.019268 -0.077205 -12.015010 -9467 2746 4 0 -1.396223 0.199493 -10.524178 -9468 2747 6 0 -7.913402 -19.479583 -10.101731 -9469 2747 4 0 -7.094305 -19.451963 -10.661033 -9470 2747 4 0 -8.430321 -18.659348 -10.306663 -9471 2748 6 0 19.510276 5.438180 15.252043 -9472 2748 4 0 19.984510 4.581515 15.209276 -9473 2748 4 0 18.693891 5.265727 15.619608 -9474 2749 6 0 14.672317 -11.674219 -8.512325 -9475 2749 4 0 15.214654 -10.997268 -8.992741 -9476 2749 4 0 15.271629 -12.444207 -8.537082 -9477 2750 6 0 -26.549973 -17.678593 10.402834 -9478 2750 4 0 -25.763998 -17.483834 10.878590 -9479 2750 4 0 -27.160376 -17.361462 11.034196 -9480 2751 6 0 5.271179 14.438724 -17.415549 -9481 2751 4 0 4.435936 14.151626 -17.136425 -9482 2751 4 0 5.468504 14.023544 -18.253894 -9483 2752 6 0 26.352424 19.290788 19.181784 -9484 2752 4 0 26.638793 20.134863 19.511609 -9485 2752 4 0 27.096123 18.959221 18.597699 -9486 2753 6 0 -26.414188 7.441925 13.185744 -9487 2753 4 0 -26.562431 6.574296 12.885418 -9488 2753 4 0 -25.860420 7.846130 12.499402 -9489 2754 6 0 5.368816 -14.762666 -4.864027 -9490 2754 4 0 6.085752 -14.950510 -4.202359 -9491 2754 4 0 5.366848 -13.815827 -5.050153 -9492 2755 6 0 -1.852223 13.402453 16.099559 -9493 2755 4 0 -0.907053 13.096616 15.950410 -9494 2755 4 0 -2.405269 12.678324 16.442150 -9495 2756 6 0 -9.537989 1.018888 -17.294635 -9496 2756 4 0 -10.174283 0.989703 -18.011766 -9497 2756 4 0 -10.088090 0.844105 -16.509242 -9498 2757 6 0 -4.825860 2.375466 13.925597 -9499 2757 4 0 -4.190822 2.787671 13.323831 -9500 2757 4 0 -5.515449 3.033395 14.087300 -9501 2758 6 0 19.580327 -10.893880 -2.747248 -9502 2758 4 0 19.742431 -11.614878 -3.428406 -9503 2758 4 0 18.622372 -10.972265 -2.491828 -9504 2759 6 0 19.256086 14.705134 10.874402 -9505 2759 4 0 20.041175 14.096992 10.573737 -9506 2759 4 0 18.760180 14.026878 11.366191 -9507 2760 6 0 4.455935 -2.361452 20.137505 -9508 2760 4 0 3.955764 -1.509452 20.278229 -9509 2760 4 0 4.874829 -2.603490 21.001857 -9510 2761 6 0 -25.974850 13.344171 -18.000007 -9511 2761 4 0 -26.267499 12.457368 -18.163639 -9512 2761 4 0 -26.149308 13.539735 -17.037715 -9513 2762 6 0 17.067973 2.763490 17.660244 -9514 2762 4 0 16.915215 3.437471 16.973312 -9515 2762 4 0 17.816632 2.203161 17.314923 -9516 2763 6 0 -11.517545 18.040646 17.714435 -9517 2763 4 0 -11.560942 17.052444 17.749537 -9518 2763 4 0 -11.413962 18.230547 18.657315 -9519 2764 6 0 25.776483 -1.160860 1.258340 -9520 2764 4 0 26.324116 -0.766625 1.925968 -9521 2764 4 0 25.733053 -0.545865 0.469204 -9522 2765 6 0 0.465549 -19.018322 6.222139 -9523 2765 4 0 0.971697 -19.764727 5.842403 -9524 2765 4 0 1.099427 -18.538006 6.759456 -9525 2766 6 0 26.241049 -6.898960 18.643166 -9526 2766 4 0 25.947101 -5.963940 18.676752 -9527 2766 4 0 25.610721 -7.314304 19.228579 -9528 2767 6 0 16.134037 -10.035813 7.553052 -9529 2767 4 0 16.959970 -10.575559 7.222214 -9530 2767 4 0 16.256703 -9.244050 7.026849 -9531 2768 6 0 22.936475 16.842438 -13.354400 -9532 2768 4 0 23.113117 16.122413 -13.952998 -9533 2768 4 0 22.167217 17.380611 -13.705166 -9534 2769 6 0 -6.174635 -12.567358 -9.759225 -9535 2769 4 0 -7.056186 -12.732423 -10.081695 -9536 2769 4 0 -6.114005 -12.989145 -8.857709 -9537 2770 6 0 13.127494 -17.049020 5.559108 -9538 2770 4 0 12.909499 -17.802411 4.984143 -9539 2770 4 0 12.442780 -16.360937 5.316305 -9540 2771 6 0 10.969996 20.716828 15.837969 -9541 2771 4 0 10.927306 20.477406 14.883647 -9542 2771 4 0 11.840696 20.306837 16.078361 -9543 2772 6 0 13.866770 18.367517 6.937702 -9544 2772 4 0 13.986130 19.326827 7.078015 -9545 2772 4 0 14.231164 17.993652 7.716184 -9546 2773 6 0 13.832788 12.943646 -11.273375 -9547 2773 4 0 14.056108 12.521321 -12.121074 -9548 2773 4 0 13.085693 12.513389 -10.836623 -9549 2774 6 0 17.127641 6.332315 -10.642348 -9550 2774 4 0 16.719396 7.195424 -10.818370 -9551 2774 4 0 16.487151 5.750510 -10.856669 -9552 2775 6 0 7.636882 -18.482195 20.548956 -9553 2775 4 0 7.346233 -18.787052 19.666640 -9554 2775 4 0 8.040956 -17.608352 20.385186 -9555 2776 6 0 15.587474 -5.247845 -16.278347 -9556 2776 4 0 16.572338 -5.288530 -16.165720 -9557 2776 4 0 15.545571 -4.364820 -16.698452 -9558 2777 6 0 0.738994 10.421255 -19.729083 -9559 2777 4 0 0.031346 10.313580 -20.434784 -9560 2777 4 0 0.614162 9.625359 -19.156085 -9561 2778 6 0 -21.514700 17.398643 -8.313387 -9562 2778 4 0 -21.261038 18.368357 -8.523940 -9563 2778 4 0 -20.879597 16.869528 -8.849738 -9564 2779 6 0 21.659354 19.006928 20.763229 -9565 2779 4 0 22.346807 19.674088 20.960616 -9566 2779 4 0 22.147607 18.139994 20.600269 -9567 2780 6 0 -13.226723 20.003033 16.874806 -9568 2780 4 0 -12.786621 19.156341 16.987387 -9569 2780 4 0 -13.521849 20.036703 15.939938 -9570 2781 6 0 12.035825 14.976596 17.699907 -9571 2781 4 0 11.299148 14.549820 17.199522 -9572 2781 4 0 12.476396 14.244702 18.105024 -9573 2782 6 0 23.014725 11.421066 -1.195826 -9574 2782 4 0 22.935852 12.296840 -0.719881 -9575 2782 4 0 23.315744 11.556530 -2.052974 -9576 2783 6 0 21.005599 -13.607746 -17.329690 -9577 2783 4 0 20.264961 -13.783556 -16.739494 -9578 2783 4 0 21.692829 -14.155085 -17.164895 -9579 2784 6 0 19.390018 13.715877 -9.986126 -9580 2784 4 0 18.766137 13.984667 -10.642161 -9581 2784 4 0 18.882708 13.584906 -9.182021 -9582 2785 6 0 21.591458 2.844658 -17.196608 -9583 2785 4 0 21.687177 3.186923 -18.110216 -9584 2785 4 0 22.488513 2.580610 -17.004967 -9585 2786 6 0 11.345787 -11.914521 18.833564 -9586 2786 4 0 10.571637 -11.320431 18.801840 -9587 2786 4 0 11.974322 -11.433977 19.432443 -9588 2787 6 0 14.649482 -19.545223 8.356804 -9589 2787 4 0 14.003078 -18.851322 8.539351 -9590 2787 4 0 15.599308 -19.149367 8.338570 -9591 2788 6 0 -11.043193 -18.255867 17.281239 -9592 2788 4 0 -10.224926 -18.639865 16.994545 -9593 2788 4 0 -11.487164 -19.009987 17.634582 -9594 2789 6 0 -26.985345 -16.412246 -14.400881 -9595 2789 4 0 -27.454047 -15.606813 -14.379952 -9596 2789 4 0 -26.081841 -16.159237 -14.585861 -9597 2790 6 0 19.102051 -15.098666 -8.764412 -9598 2790 4 0 19.000932 -15.521094 -9.678404 -9599 2790 4 0 19.453733 -14.174347 -8.910357 -9600 2791 6 0 6.376012 19.349948 5.671135 -9601 2791 4 0 6.687862 20.029372 5.077314 -9602 2791 4 0 5.561947 19.709229 6.038539 -9603 2792 6 0 -17.499998 -13.507016 9.684050 -9604 2792 4 0 -17.138230 -13.962493 10.435127 -9605 2792 4 0 -17.640659 -14.284861 9.096248 -9606 2793 6 0 17.699807 -14.814698 11.789809 -9607 2793 4 0 17.014114 -15.422000 11.369433 -9608 2793 4 0 17.429825 -14.840034 12.737607 -9609 2794 6 0 12.888820 1.939624 -17.757092 -9610 2794 4 0 12.023501 2.459281 -17.778689 -9611 2794 4 0 12.922205 1.789197 -16.837552 -9612 2795 6 0 -27.142428 -4.791675 -8.608453 -9613 2795 4 0 -27.117499 -4.179414 -9.373351 -9614 2795 4 0 -26.563163 -5.561210 -8.869517 -9615 2796 6 0 18.673615 12.370651 6.319082 -9616 2796 4 0 18.699459 11.385010 6.253835 -9617 2796 4 0 18.583561 12.688817 5.434396 -9618 2797 6 0 10.178364 -12.605036 -17.136500 -9619 2797 4 0 10.699128 -12.924478 -16.370473 -9620 2797 4 0 9.489391 -13.311993 -17.195335 -9621 2798 6 0 7.257958 3.289333 16.273726 -9622 2798 4 0 7.801701 4.023865 16.654114 -9623 2798 4 0 6.831954 2.726700 16.945762 -9624 2799 6 0 -22.793525 -4.351149 1.112435 -9625 2799 4 0 -23.178683 -4.998212 1.686297 -9626 2799 4 0 -22.676437 -3.490820 1.495852 -9627 2800 6 0 10.431915 10.150385 6.416596 -9628 2800 4 0 9.504032 10.369808 6.525826 -9629 2800 4 0 10.818627 10.534325 7.222492 -9630 2801 6 0 16.181318 -18.659361 -4.530126 -9631 2801 4 0 16.539581 -18.491898 -3.640666 -9632 2801 4 0 16.723714 -18.083763 -5.128977 -9633 2802 6 0 24.085884 14.331318 -5.367949 -9634 2802 4 0 25.027794 14.190212 -5.345575 -9635 2802 4 0 23.725489 13.957121 -4.548465 -9636 2803 6 0 27.476267 18.553177 -13.120949 -9637 2803 4 0 27.278972 18.193548 -12.233661 -9638 2803 4 0 26.663894 18.473337 -13.667172 -9639 2804 6 0 -3.429941 10.490939 1.565767 -9640 2804 4 0 -4.189571 9.996973 1.988486 -9641 2804 4 0 -2.756994 10.462029 2.200444 -9642 2805 6 0 -23.874077 -2.287625 -14.406474 -9643 2805 4 0 -24.326434 -2.528790 -13.612508 -9644 2805 4 0 -23.725821 -1.349091 -14.150316 -9645 2806 6 0 6.913124 -5.939231 14.325196 -9646 2806 4 0 7.603991 -5.675852 13.760866 -9647 2806 4 0 7.141094 -6.840164 14.586103 -9648 2807 6 0 -9.435672 7.567999 -12.736311 -9649 2807 4 0 -10.092450 7.532344 -13.480723 -9650 2807 4 0 -9.904849 7.166688 -11.970693 -9651 2808 6 0 -23.627772 20.561997 -10.291642 -9652 2808 4 0 -23.140188 21.403417 -10.120507 -9653 2808 4 0 -23.127330 19.939171 -10.860601 -9654 2809 6 0 -11.957151 -10.758767 10.380421 -9655 2809 4 0 -12.914975 -11.025570 10.474104 -9656 2809 4 0 -11.726864 -10.328942 11.254768 -9657 2810 6 0 -4.055025 -16.357375 12.638110 -9658 2810 4 0 -4.145602 -15.539307 12.188903 -9659 2810 4 0 -3.229424 -16.754351 12.492730 -9660 2811 6 0 -25.660951 2.977355 3.644209 -9661 2811 4 0 -25.405729 3.847728 3.825406 -9662 2811 4 0 -26.592530 3.015138 3.572516 -9663 2812 6 0 -1.059386 -9.814838 20.360215 -9664 2812 4 0 -0.131280 -9.654603 20.258879 -9665 2812 4 0 -1.404044 -10.175480 19.521783 -9666 2813 6 0 -13.274409 -12.355600 6.487680 -9667 2813 4 0 -14.175655 -12.374044 6.195808 -9668 2813 4 0 -12.869043 -11.626070 5.932127 -9669 2814 6 0 -17.154642 -17.337539 -2.602671 -9670 2814 4 0 -17.684268 -17.711860 -3.323318 -9671 2814 4 0 -17.542126 -17.638492 -1.768263 -9672 2815 6 0 -8.431986 -14.331490 -18.620988 -9673 2815 4 0 -8.525378 -14.518157 -17.652352 -9674 2815 4 0 -9.070115 -15.091242 -18.962501 -9675 2816 6 0 9.227734 -14.707755 8.334683 -9676 2816 4 0 8.912750 -14.297078 9.180099 -9677 2816 4 0 10.141362 -14.864367 8.460368 -9678 2817 6 0 -18.940927 -7.749229 13.986681 -9679 2817 4 0 -18.998677 -8.736236 14.046068 -9680 2817 4 0 -18.235160 -7.570709 13.352401 -9681 2818 6 0 -3.315848 14.486693 12.321029 -9682 2818 4 0 -2.891118 14.428375 11.433488 -9683 2818 4 0 -3.009257 15.355409 12.649294 -9684 2819 6 0 15.258302 19.640916 -9.495586 -9685 2819 4 0 15.255790 19.268774 -10.417780 -9686 2819 4 0 14.362167 19.825595 -9.329840 -9687 2820 6 0 -27.308827 -17.253050 -3.549375 -9688 2820 4 0 -27.016406 -16.762829 -2.812626 -9689 2820 4 0 -26.618283 -17.291456 -4.216078 -9690 2821 6 0 -17.469474 9.268976 13.624133 -9691 2821 4 0 -17.003981 8.734120 14.281842 -9692 2821 4 0 -17.567961 10.133200 14.047196 -9693 2822 6 0 20.896249 -8.668059 -15.648620 -9694 2822 4 0 21.320419 -8.468808 -14.797523 -9695 2822 4 0 20.936901 -9.602395 -15.783740 -9696 2823 6 0 6.591038 13.945476 -6.677072 -9697 2823 4 0 6.387452 12.989743 -6.664344 -9698 2823 4 0 7.535066 14.092588 -6.670539 -9699 2824 6 0 10.072634 7.484666 6.879205 -9700 2824 4 0 9.218040 7.159172 6.564500 -9701 2824 4 0 10.122197 8.421774 6.591601 -9702 2825 6 0 -23.792275 5.951536 11.433857 -9703 2825 4 0 -23.560372 6.167334 12.401775 -9704 2825 4 0 -23.076924 6.327786 10.856454 -9705 2826 6 0 12.132840 3.851033 -6.616749 -9706 2826 4 0 12.785083 4.216573 -7.191058 -9707 2826 4 0 12.512257 3.897859 -5.719717 -9708 2827 6 0 5.351683 6.078049 -14.255102 -9709 2827 4 0 5.013358 6.855687 -13.813494 -9710 2827 4 0 5.137704 6.252225 -15.124513 -9711 2828 6 0 13.138157 -8.336001 1.684188 -9712 2828 4 0 12.595335 -8.813255 1.081700 -9713 2828 4 0 13.382247 -7.459796 1.264391 -9714 2829 6 0 -10.347292 10.399621 -12.874082 -9715 2829 4 0 -10.494653 9.452942 -12.814808 -9716 2829 4 0 -10.828227 10.775518 -13.651328 -9717 2830 6 0 9.152946 -17.315622 6.377534 -9718 2830 4 0 8.873272 -17.655423 5.536131 -9719 2830 4 0 9.644625 -16.466151 6.247065 -9720 2831 6 0 -2.422355 -14.638070 -20.255326 -9721 2831 4 0 -2.466677 -15.603006 -20.125891 -9722 2831 4 0 -2.234204 -14.630853 -21.192244 -9723 2832 6 0 7.306601 16.960372 -8.356338 -9724 2832 4 0 7.335426 17.713766 -8.966973 -9725 2832 4 0 6.389385 16.681622 -8.314986 -9726 2833 6 0 -11.068015 -16.691381 7.975224 -9727 2833 4 0 -11.725330 -17.098102 8.584468 -9728 2833 4 0 -11.554703 -15.995305 7.530686 -9729 2834 6 0 2.086903 -14.793471 13.604939 -9730 2834 4 0 2.196059 -15.680487 13.948768 -9731 2834 4 0 2.568411 -14.755595 12.759739 -9732 2835 6 0 -17.658207 18.277094 2.186303 -9733 2835 4 0 -17.424686 17.674490 1.472227 -9734 2835 4 0 -18.244002 18.909136 1.776504 -9735 2836 6 0 24.999903 10.057013 0.434977 -9736 2836 4 0 24.330807 10.404778 -0.199378 -9737 2836 4 0 24.595385 9.375992 1.021837 - -Bonds - -1 1 1 2 -2 2 1 5 -3 2 1 6 -4 2 1 7 -5 3 2 3 -6 4 2 8 -7 5 2 9 -8 6 3 4 -9 7 3 20 -10 8 9 10 -11 9 9 13 -12 9 9 14 -13 10 10 11 -14 9 10 15 -15 9 10 16 -16 10 11 12 -17 9 12 17 -18 9 12 18 -19 9 12 19 -20 11 20 21 -21 12 20 24 -22 3 21 22 -23 4 21 25 -24 5 21 26 -25 6 22 23 -26 7 22 37 -27 8 26 27 -28 9 26 31 -29 9 26 32 -30 13 27 28 -31 9 27 33 -32 9 27 34 -33 6 28 29 -34 7 28 30 -35 12 30 35 -36 12 30 36 -37 11 37 38 -38 12 37 41 -39 3 38 39 -40 4 38 42 -41 14 38 43 -42 6 39 40 -43 7 39 56 -44 5 43 44 -45 5 43 45 -46 4 43 47 -47 8 44 46 -48 9 44 48 -49 9 44 49 -50 9 45 50 -51 9 45 51 -52 9 45 52 -53 9 46 53 -54 9 46 54 -55 9 46 55 -56 11 56 57 -57 12 56 60 -58 3 57 58 -59 4 57 61 -60 5 57 62 -61 6 58 59 -62 7 58 76 -63 15 62 63 -64 9 62 69 -65 9 62 70 -66 16 63 64 -67 16 63 65 -68 16 64 66 -69 17 64 71 -70 16 65 67 -71 17 65 72 -72 16 66 68 -73 17 66 73 -74 16 67 68 -75 17 67 74 -76 17 68 75 -77 11 76 77 -78 12 76 80 -79 3 77 78 -80 4 77 81 -81 14 77 82 -82 6 78 79 -83 7 78 92 -84 5 82 83 -85 5 82 84 -86 4 82 85 -87 9 83 86 -88 9 83 87 -89 9 83 88 -90 9 84 89 -91 9 84 90 -92 9 84 91 -93 11 92 93 -94 12 92 96 -95 3 93 94 -96 4 93 97 -97 5 93 98 -98 6 94 95 -99 7 94 114 -100 8 98 99 -101 9 98 103 -102 9 98 104 -103 8 99 100 -104 9 99 105 -105 9 99 106 -106 8 100 101 -107 9 100 107 -108 9 100 108 -109 18 101 102 -110 9 101 109 -111 9 101 110 -112 19 102 111 -113 19 102 112 -114 19 102 113 -115 11 114 115 -116 12 114 118 -117 3 115 116 -118 4 115 119 -119 14 115 120 -120 6 116 117 -121 7 116 128 -122 20 120 121 -123 5 120 122 -124 4 120 123 -125 21 121 124 -126 9 122 125 -127 9 122 126 -128 9 122 127 -129 11 128 129 -130 12 128 132 -131 3 129 130 -132 4 129 133 -133 5 129 134 -134 6 130 131 -135 7 130 147 -136 5 134 135 -137 9 134 138 -138 9 134 139 -139 5 135 136 -140 5 135 137 -141 4 135 140 -142 9 136 141 -143 9 136 142 -144 9 136 143 -145 9 137 144 -146 9 137 145 -147 9 137 146 -148 11 147 148 -149 12 147 151 -150 3 148 149 -151 4 148 152 -152 14 148 153 -153 6 149 150 -154 7 149 161 -155 20 153 154 -156 5 153 155 -157 4 153 156 -158 21 154 157 -159 9 155 158 -160 9 155 159 -161 9 155 160 -162 22 161 162 -163 12 161 165 -164 23 162 163 -165 24 162 166 -166 24 162 167 -167 6 163 164 -168 7 163 168 -169 11 168 169 -170 12 168 172 -171 3 169 170 -172 4 169 173 -173 5 169 174 -174 6 170 171 -175 7 170 190 -176 8 174 175 -177 9 174 179 -178 9 174 180 -179 8 175 176 -180 9 175 181 -181 9 175 182 -182 8 176 177 -183 9 176 183 -184 9 176 184 -185 18 177 178 -186 9 177 185 -187 9 177 186 -188 19 178 187 -189 19 178 188 -190 19 178 189 -191 11 190 191 -192 12 190 194 -193 3 191 192 -194 4 191 195 -195 14 191 196 -196 6 192 193 -197 7 192 204 -198 20 196 197 -199 5 196 198 -200 4 196 199 -201 21 197 200 -202 9 198 201 -203 9 198 202 -204 9 198 203 -205 11 204 205 -206 12 204 208 -207 3 205 206 -208 4 205 209 -209 14 205 210 -210 6 206 207 -211 7 206 223 -212 5 210 211 -213 5 210 212 -214 4 210 214 -215 8 211 213 -216 9 211 215 -217 9 211 216 -218 9 212 217 -219 9 212 218 -220 9 212 219 -221 9 213 220 -222 9 213 221 -223 9 213 222 -224 11 223 224 -225 12 223 227 -226 3 224 225 -227 4 224 228 -228 14 224 229 -229 6 225 226 -230 7 225 237 -231 20 229 230 -232 5 229 231 -233 4 229 232 -234 21 230 233 -235 9 231 234 -236 9 231 235 -237 9 231 236 -238 11 237 238 -239 12 237 241 -240 3 238 239 -241 4 238 242 -242 5 238 243 -243 6 239 240 -244 7 239 256 -245 5 243 244 -246 9 243 247 -247 9 243 248 -248 5 244 245 -249 5 244 246 -250 4 244 249 -251 9 245 250 -252 9 245 251 -253 9 245 252 -254 9 246 253 -255 9 246 254 -256 9 246 255 -257 11 256 257 -258 12 256 260 -259 3 257 258 -260 4 257 261 -261 5 257 262 -262 6 258 259 -263 7 258 271 -264 8 262 263 -265 9 262 267 -266 9 262 268 -267 25 263 264 -268 9 263 269 -269 9 263 270 -270 26 264 265 -271 26 264 266 -272 11 271 272 -273 12 271 275 -274 3 272 273 -275 4 272 276 -276 14 272 277 -277 6 273 274 -278 7 273 287 -279 5 277 278 -280 5 277 279 -281 4 277 280 -282 9 278 281 -283 9 278 282 -284 9 278 283 -285 9 279 284 -286 9 279 285 -287 9 279 286 -288 11 287 288 -289 12 287 291 -290 3 288 289 -291 4 288 292 -292 5 288 293 -293 6 289 290 -294 27 289 302 -295 8 293 294 -296 9 293 298 -297 9 293 299 -298 25 294 295 -299 9 294 300 -300 9 294 301 -301 26 295 296 -302 26 295 297 -303 28 302 303 -304 29 302 309 -305 3 303 304 -306 4 303 306 -307 30 303 307 -308 6 304 305 -309 7 304 316 -310 31 307 308 -311 32 307 310 -312 32 307 311 -313 31 308 309 -314 32 308 312 -315 32 308 313 -316 33 309 314 -317 33 309 315 -318 11 316 317 -319 12 316 320 -320 3 317 318 -321 4 317 321 -322 5 317 322 -323 6 318 319 -324 7 318 327 -325 34 322 323 -326 9 322 324 -327 9 322 325 -328 21 323 326 -329 11 327 328 -330 12 327 331 -331 3 328 329 -332 4 328 332 -333 5 328 333 -334 6 329 330 -335 7 329 339 -336 25 333 334 -337 9 333 337 -338 9 333 338 -339 26 334 335 -340 26 334 336 -341 11 339 340 -342 12 339 343 -343 3 340 341 -344 4 340 344 -345 14 340 345 -346 6 341 342 -347 7 341 353 -348 20 345 346 -349 5 345 347 -350 4 345 348 -351 21 346 349 -352 9 347 350 -353 9 347 351 -354 9 347 352 -355 11 353 354 -356 12 353 357 -357 3 354 355 -358 4 354 358 -359 14 354 359 -360 6 355 356 -361 7 355 372 -362 5 359 360 -363 5 359 361 -364 4 359 363 -365 8 360 362 -366 9 360 364 -367 9 360 365 -368 9 361 366 -369 9 361 367 -370 9 361 368 -371 9 362 369 -372 9 362 370 -373 9 362 371 -374 11 372 373 -375 12 372 376 -376 3 373 374 -377 4 373 377 -378 5 373 378 -379 6 374 375 -380 7 374 387 -381 8 378 379 -382 9 378 383 -383 9 378 384 -384 25 379 380 -385 9 379 385 -386 9 379 386 -387 26 380 381 -388 26 380 382 -389 11 387 388 -390 12 387 391 -391 3 388 389 -392 4 388 392 -393 5 388 393 -394 6 389 390 -395 7 389 401 -396 13 393 394 -397 9 393 397 -398 9 393 398 -399 6 394 395 -400 7 394 396 -401 12 396 399 -402 12 396 400 -403 11 401 402 -404 12 401 405 -405 3 402 403 -406 4 402 406 -407 14 402 407 -408 6 403 404 -409 7 403 417 -410 5 407 408 -411 5 407 409 -412 4 407 410 -413 9 408 411 -414 9 408 412 -415 9 408 413 -416 9 409 414 -417 9 409 415 -418 9 409 416 -419 11 417 418 -420 12 417 421 -421 3 418 419 -422 4 418 422 -423 5 418 423 -424 6 419 420 -425 7 419 439 -426 8 423 424 -427 9 423 428 -428 9 423 429 -429 8 424 425 -430 9 424 430 -431 9 424 431 -432 8 425 426 -433 9 425 432 -434 9 425 433 -435 18 426 427 -436 9 426 434 -437 9 426 435 -438 19 427 436 -439 19 427 437 -440 19 427 438 -441 11 439 440 -442 12 439 443 -443 3 440 441 -444 4 440 444 -445 5 440 445 -446 6 441 442 -447 7 441 449 -448 9 445 446 -449 9 445 447 -450 9 445 448 -451 11 449 450 -452 12 449 453 -453 3 450 451 -454 4 450 454 -455 5 450 455 -456 6 451 452 -457 7 451 471 -458 8 455 456 -459 9 455 460 -460 9 455 461 -461 8 456 457 -462 9 456 462 -463 9 456 463 -464 8 457 458 -465 9 457 464 -466 9 457 465 -467 18 458 459 -468 9 458 466 -469 9 458 467 -470 19 459 468 -471 19 459 469 -472 19 459 470 -473 11 471 472 -474 12 471 475 -475 3 472 473 -476 4 472 476 -477 14 472 477 -478 6 473 474 -479 7 473 490 -480 5 477 478 -481 5 477 479 -482 4 477 481 -483 8 478 480 -484 9 478 482 -485 9 478 483 -486 9 479 484 -487 9 479 485 -488 9 479 486 -489 9 480 487 -490 9 480 488 -491 9 480 489 -492 11 490 491 -493 12 490 494 -494 3 491 492 -495 4 491 495 -496 5 491 496 -497 6 492 493 -498 7 492 507 -499 8 496 497 -500 9 496 501 -501 9 496 502 -502 13 497 498 -503 9 497 503 -504 9 497 504 -505 6 498 499 -506 7 498 500 -507 12 500 505 -508 12 500 506 -509 11 507 508 -510 12 507 511 -511 3 508 509 -512 4 508 512 -513 5 508 513 -514 6 509 510 -515 7 509 519 -516 25 513 514 -517 9 513 517 -518 9 513 518 -519 26 514 515 -520 26 514 516 -521 11 519 520 -522 12 519 523 -523 3 520 521 -524 4 520 524 -525 5 520 525 -526 6 521 522 -527 7 521 541 -528 8 525 526 -529 9 525 530 -530 9 525 531 -531 8 526 527 -532 9 526 532 -533 9 526 533 -534 8 527 528 -535 9 527 534 -536 9 527 535 -537 18 528 529 -538 9 528 536 -539 9 528 537 -540 19 529 538 -541 19 529 539 -542 19 529 540 -543 11 541 542 -544 12 541 545 -545 3 542 543 -546 4 542 546 -547 5 542 547 -548 6 543 544 -549 7 543 556 -550 8 547 548 -551 9 547 552 -552 9 547 553 -553 25 548 549 -554 9 548 554 -555 9 548 555 -556 26 549 550 -557 26 549 551 -558 22 556 557 -559 12 556 560 -560 23 557 558 -561 24 557 561 -562 24 557 562 -563 6 558 559 -564 7 558 563 -565 11 563 564 -566 12 563 567 -567 3 564 565 -568 4 564 568 -569 14 564 569 -570 6 565 566 -571 27 565 582 -572 5 569 570 -573 5 569 571 -574 4 569 573 -575 8 570 572 -576 9 570 574 -577 9 570 575 -578 9 571 576 -579 9 571 577 -580 9 571 578 -581 9 572 579 -582 9 572 580 -583 9 572 581 -584 28 582 583 -585 29 582 589 -586 3 583 584 -587 4 583 586 -588 30 583 587 -589 6 584 585 -590 27 584 596 -591 31 587 588 -592 32 587 590 -593 32 587 591 -594 31 588 589 -595 32 588 592 -596 32 588 593 -597 33 589 594 -598 33 589 595 -599 28 596 597 -600 29 596 603 -601 3 597 598 -602 4 597 600 -603 30 597 601 -604 6 598 599 -605 7 598 610 -606 31 601 602 -607 32 601 604 -608 32 601 605 -609 31 602 603 -610 32 602 606 -611 32 602 607 -612 33 603 608 -613 33 603 609 -614 11 610 611 -615 12 610 614 -616 3 611 612 -617 4 611 615 -618 5 611 616 -619 6 612 613 -620 7 612 622 -621 25 616 617 -622 9 616 620 -623 9 616 621 -624 26 617 618 -625 26 617 619 -626 11 622 623 -627 12 622 626 -628 3 623 624 -629 4 623 627 -630 5 623 628 -631 6 624 625 -632 7 624 639 -633 8 628 629 -634 9 628 633 -635 9 628 634 -636 13 629 630 -637 9 629 635 -638 9 629 636 -639 6 630 631 -640 7 630 632 -641 12 632 637 -642 12 632 638 -643 11 639 640 -644 12 639 643 -645 3 640 641 -646 4 640 644 -647 5 640 645 -648 6 641 642 -649 7 641 656 -650 8 645 646 -651 9 645 650 -652 9 645 651 -653 13 646 647 -654 9 646 652 -655 9 646 653 -656 6 647 648 -657 7 647 649 -658 12 649 654 -659 12 649 655 -660 11 656 657 -661 12 656 660 -662 3 657 658 -663 4 657 661 -664 5 657 662 -665 6 658 659 -666 7 658 680 -667 8 662 663 -668 9 662 669 -669 9 662 670 -670 8 663 664 -671 9 663 671 -672 9 663 672 -673 35 664 665 -674 9 664 673 -675 9 664 674 -676 36 665 666 -677 37 665 675 -678 36 666 667 -679 36 666 668 -680 37 667 676 -681 37 667 677 -682 37 668 678 -683 37 668 679 -684 11 680 681 -685 12 680 684 -686 3 681 682 -687 4 681 685 -688 5 681 686 -689 6 682 683 -690 7 682 699 -691 5 686 687 -692 9 686 690 -693 9 686 691 -694 5 687 688 -695 5 687 689 -696 4 687 692 -697 9 688 693 -698 9 688 694 -699 9 688 695 -700 9 689 696 -701 9 689 697 -702 9 689 698 -703 11 699 700 -704 12 699 703 -705 3 700 701 -706 4 700 704 -707 14 700 705 -708 6 701 702 -709 7 701 718 -710 5 705 706 -711 5 705 707 -712 4 705 709 -713 8 706 708 -714 9 706 710 -715 9 706 711 -716 9 707 712 -717 9 707 713 -718 9 707 714 -719 9 708 715 -720 9 708 716 -721 9 708 717 -722 11 718 719 -723 12 718 722 -724 3 719 720 -725 4 719 723 -726 5 719 724 -727 6 720 721 -728 7 720 738 -729 15 724 725 -730 9 724 731 -731 9 724 732 -732 16 725 726 -733 16 725 727 -734 16 726 728 -735 17 726 733 -736 16 727 729 -737 17 727 734 -738 16 728 730 -739 17 728 735 -740 16 729 730 -741 17 729 736 -742 17 730 737 -743 11 738 739 -744 12 738 742 -745 3 739 740 -746 4 739 743 -747 5 739 744 -748 6 740 741 -749 7 740 748 -750 9 744 745 -751 9 744 746 -752 9 744 747 -753 22 748 749 -754 12 748 752 -755 23 749 750 -756 24 749 753 -757 24 749 754 -758 6 750 751 -759 7 750 755 -760 11 755 756 -761 12 755 759 -762 3 756 757 -763 4 756 760 -764 5 756 761 -765 6 757 758 -766 7 757 777 -767 8 761 762 -768 9 761 766 -769 9 761 767 -770 8 762 763 -771 9 762 768 -772 9 762 769 -773 8 763 764 -774 9 763 770 -775 9 763 771 -776 18 764 765 -777 9 764 772 -778 9 764 773 -779 19 765 774 -780 19 765 775 -781 19 765 776 -782 11 777 778 -783 12 777 781 -784 3 778 779 -785 4 778 782 -786 5 778 783 -787 6 779 780 -788 7 779 794 -789 8 783 784 -790 9 783 788 -791 9 783 789 -792 13 784 785 -793 9 784 790 -794 9 784 791 -795 6 785 786 -796 7 785 787 -797 12 787 792 -798 12 787 793 -799 11 794 795 -800 12 794 798 -801 3 795 796 -802 4 795 799 -803 5 795 800 -804 6 796 797 -805 7 796 813 -806 5 800 801 -807 9 800 804 -808 9 800 805 -809 5 801 802 -810 5 801 803 -811 4 801 806 -812 9 802 807 -813 9 802 808 -814 9 802 809 -815 9 803 810 -816 9 803 811 -817 9 803 812 -818 11 813 814 -819 12 813 817 -820 3 814 815 -821 4 814 818 -822 5 814 819 -823 6 815 816 -824 7 815 828 -825 8 819 820 -826 9 819 824 -827 9 819 825 -828 25 820 821 -829 9 820 826 -830 9 820 827 -831 26 821 822 -832 26 821 823 -833 11 828 829 -834 12 828 832 -835 3 829 830 -836 4 829 833 -837 5 829 834 -838 6 830 831 -839 7 830 840 -840 25 834 835 -841 9 834 838 -842 9 834 839 -843 26 835 836 -844 26 835 837 -845 22 840 841 -846 12 840 844 -847 23 841 842 -848 24 841 845 -849 24 841 846 -850 6 842 843 -851 7 842 847 -852 11 847 848 -853 12 847 851 -854 3 848 849 -855 4 848 852 -856 5 848 853 -857 6 849 850 -858 7 849 871 -859 8 853 854 -860 9 853 860 -861 9 853 861 -862 8 854 855 -863 9 854 862 -864 9 854 863 -865 35 855 856 -866 9 855 864 -867 9 855 865 -868 36 856 857 -869 37 856 866 -870 36 857 858 -871 36 857 859 -872 37 858 867 -873 37 858 868 -874 37 859 869 -875 37 859 870 -876 11 871 872 -877 12 871 875 -878 3 872 873 -879 4 872 876 -880 14 872 877 -881 6 873 874 -882 7 873 885 -883 20 877 878 -884 5 877 879 -885 4 877 880 -886 21 878 881 -887 9 879 882 -888 9 879 883 -889 9 879 884 -890 11 885 886 -891 12 885 889 -892 3 886 887 -893 4 886 890 -894 5 886 891 -895 6 887 888 -896 7 887 904 -897 5 891 892 -898 9 891 895 -899 9 891 896 -900 5 892 893 -901 5 892 894 -902 4 892 897 -903 9 893 898 -904 9 893 899 -905 9 893 900 -906 9 894 901 -907 9 894 902 -908 9 894 903 -909 11 904 905 -910 12 904 908 -911 3 905 906 -912 4 905 909 -913 5 905 910 -914 6 906 907 -915 7 906 915 -916 34 910 911 -917 9 910 912 -918 9 910 913 -919 21 911 914 -920 11 915 916 -921 12 915 919 -922 3 916 917 -923 4 916 920 -924 5 916 921 -925 6 917 918 -926 7 917 927 -927 25 921 922 -928 9 921 925 -929 9 921 926 -930 26 922 923 -931 26 922 924 -932 11 927 928 -933 12 927 931 -934 3 928 929 -935 4 928 932 -936 5 928 933 -937 6 929 930 -938 7 929 948 -939 15 933 934 -940 9 933 941 -941 9 933 942 -942 16 934 935 -943 16 934 936 -944 16 935 937 -945 17 935 943 -946 16 936 938 -947 17 936 944 -948 16 937 939 -949 17 937 945 -950 16 938 939 -951 17 938 946 -952 38 939 940 -953 39 940 947 -954 11 948 949 -955 12 948 952 -956 3 949 950 -957 4 949 953 -958 5 949 954 -959 6 950 951 -960 7 950 962 -961 13 954 955 -962 9 954 958 -963 9 954 959 -964 6 955 956 -965 7 955 957 -966 12 957 960 -967 12 957 961 -968 11 962 963 -969 12 962 966 -970 3 963 964 -971 4 963 967 -972 14 963 968 -973 6 964 965 -974 7 964 981 -975 5 968 969 -976 5 968 970 -977 4 968 972 -978 8 969 971 -979 9 969 973 -980 9 969 974 -981 9 970 975 -982 9 970 976 -983 9 970 977 -984 9 971 978 -985 9 971 979 -986 9 971 980 -987 11 981 982 -988 12 981 985 -989 3 982 983 -990 4 982 986 -991 5 982 987 -992 6 983 984 -993 7 983 998 -994 8 987 988 -995 9 987 992 -996 9 987 993 -997 13 988 989 -998 9 988 994 -999 9 988 995 -1000 6 989 990 -1001 7 989 991 -1002 12 991 996 -1003 12 991 997 -1004 11 998 999 -1005 12 998 1002 -1006 3 999 1000 -1007 4 999 1003 -1008 5 999 1004 -1009 6 1000 1001 -1010 7 1000 1020 -1011 8 1004 1005 -1012 9 1004 1009 -1013 9 1004 1010 -1014 8 1005 1006 -1015 9 1005 1011 -1016 9 1005 1012 -1017 8 1006 1007 -1018 9 1006 1013 -1019 9 1006 1014 -1020 18 1007 1008 -1021 9 1007 1015 -1022 9 1007 1016 -1023 19 1008 1017 -1024 19 1008 1018 -1025 19 1008 1019 -1026 11 1020 1021 -1027 12 1020 1024 -1028 3 1021 1022 -1029 4 1021 1025 -1030 5 1021 1026 -1031 6 1022 1023 -1032 7 1022 1035 -1033 8 1026 1027 -1034 9 1026 1031 -1035 9 1026 1032 -1036 25 1027 1028 -1037 9 1027 1033 -1038 9 1027 1034 -1039 26 1028 1029 -1040 26 1028 1030 -1041 11 1035 1036 -1042 12 1035 1039 -1043 3 1036 1037 -1044 4 1036 1040 -1045 5 1036 1041 -1046 6 1037 1038 -1047 7 1037 1046 -1048 34 1041 1042 -1049 9 1041 1043 -1050 9 1041 1044 -1051 21 1042 1045 -1052 11 1046 1047 -1053 12 1046 1050 -1054 3 1047 1048 -1055 4 1047 1051 -1056 14 1047 1052 -1057 6 1048 1049 -1058 7 1048 1060 -1059 20 1052 1053 -1060 5 1052 1054 -1061 4 1052 1055 -1062 21 1053 1056 -1063 9 1054 1057 -1064 9 1054 1058 -1065 9 1054 1059 -1066 11 1060 1061 -1067 12 1060 1064 -1068 3 1061 1062 -1069 4 1061 1065 -1070 5 1061 1066 -1071 6 1062 1063 -1072 7 1062 1079 -1073 5 1066 1067 -1074 9 1066 1070 -1075 9 1066 1071 -1076 5 1067 1068 -1077 5 1067 1069 -1078 4 1067 1072 -1079 9 1068 1073 -1080 9 1068 1074 -1081 9 1068 1075 -1082 9 1069 1076 -1083 9 1069 1077 -1084 9 1069 1078 -1085 11 1079 1080 -1086 12 1079 1083 -1087 3 1080 1081 -1088 4 1080 1084 -1089 5 1080 1085 -1090 6 1081 1082 -1091 7 1081 1097 -1092 40 1085 1086 -1093 9 1085 1091 -1094 9 1085 1092 -1095 41 1086 1087 -1096 42 1086 1088 -1097 43 1087 1089 -1098 44 1087 1093 -1099 41 1088 1090 -1100 45 1088 1094 -1101 43 1089 1090 -1102 46 1089 1095 -1103 44 1090 1096 -1104 11 1097 1098 -1105 12 1097 1101 -1106 3 1098 1099 -1107 4 1098 1102 -1108 5 1098 1103 -1109 6 1099 1100 -1110 7 1099 1116 -1111 5 1103 1104 -1112 9 1103 1107 -1113 9 1103 1108 -1114 5 1104 1105 -1115 5 1104 1106 -1116 4 1104 1109 -1117 9 1105 1110 -1118 9 1105 1111 -1119 9 1105 1112 -1120 9 1106 1113 -1121 9 1106 1114 -1122 9 1106 1115 -1123 11 1116 1117 -1124 12 1116 1120 -1125 3 1117 1118 -1126 4 1117 1121 -1127 14 1117 1122 -1128 6 1118 1119 -1129 7 1118 1132 -1130 5 1122 1123 -1131 5 1122 1124 -1132 4 1122 1125 -1133 9 1123 1126 -1134 9 1123 1127 -1135 9 1123 1128 -1136 9 1124 1129 -1137 9 1124 1130 -1138 9 1124 1131 -1139 11 1132 1133 -1140 12 1132 1136 -1141 3 1133 1134 -1142 4 1133 1137 -1143 5 1133 1138 -1144 6 1134 1135 -1145 7 1134 1151 -1146 5 1138 1139 -1147 9 1138 1142 -1148 9 1138 1143 -1149 5 1139 1140 -1150 5 1139 1141 -1151 4 1139 1144 -1152 9 1140 1145 -1153 9 1140 1146 -1154 9 1140 1147 -1155 9 1141 1148 -1156 9 1141 1149 -1157 9 1141 1150 -1158 11 1151 1152 -1159 12 1151 1155 -1160 3 1152 1153 -1161 4 1152 1156 -1162 5 1152 1157 -1163 6 1153 1154 -1164 7 1153 1175 -1165 8 1157 1158 -1166 9 1157 1164 -1167 9 1157 1165 -1168 8 1158 1159 -1169 9 1158 1166 -1170 9 1158 1167 -1171 35 1159 1160 -1172 9 1159 1168 -1173 9 1159 1169 -1174 36 1160 1161 -1175 37 1160 1170 -1176 36 1161 1162 -1177 36 1161 1163 -1178 37 1162 1171 -1179 37 1162 1172 -1180 37 1163 1173 -1181 37 1163 1174 -1182 11 1175 1176 -1183 12 1175 1179 -1184 3 1176 1177 -1185 4 1176 1180 -1186 5 1176 1181 -1187 6 1177 1178 -1188 7 1177 1194 -1189 5 1181 1182 -1190 9 1181 1185 -1191 9 1181 1186 -1192 5 1182 1183 -1193 5 1182 1184 -1194 4 1182 1187 -1195 9 1183 1188 -1196 9 1183 1189 -1197 9 1183 1190 -1198 9 1184 1191 -1199 9 1184 1192 -1200 9 1184 1193 -1201 11 1194 1195 -1202 12 1194 1198 -1203 3 1195 1196 -1204 4 1195 1199 -1205 5 1195 1200 -1206 6 1196 1197 -1207 7 1196 1218 -1208 8 1200 1201 -1209 9 1200 1207 -1210 9 1200 1208 -1211 8 1201 1202 -1212 9 1201 1209 -1213 9 1201 1210 -1214 35 1202 1203 -1215 9 1202 1211 -1216 9 1202 1212 -1217 36 1203 1204 -1218 37 1203 1213 -1219 36 1204 1205 -1220 36 1204 1206 -1221 37 1205 1214 -1222 37 1205 1215 -1223 37 1206 1216 -1224 37 1206 1217 -1225 22 1218 1219 -1226 12 1218 1222 -1227 23 1219 1220 -1228 24 1219 1223 -1229 24 1219 1224 -1230 6 1220 1221 -1231 7 1220 1225 -1232 22 1225 1226 -1233 12 1225 1229 -1234 47 1226 1227 -1235 24 1226 1230 -1236 24 1226 1231 -1237 26 1227 1228 -1238 26 1227 1232 -1239 48 1233 1234 -1240 48 1233 1235 -1241 48 1236 1237 -1242 48 1236 1238 -1243 48 1239 1240 -1244 48 1239 1241 -1245 48 1242 1243 -1246 48 1242 1244 -1247 48 1245 1246 -1248 48 1245 1247 -1249 48 1248 1249 -1250 48 1248 1250 -1251 48 1251 1252 -1252 48 1251 1253 -1253 48 1254 1255 -1254 48 1254 1256 -1255 48 1257 1258 -1256 48 1257 1259 -1257 48 1260 1261 -1258 48 1260 1262 -1259 48 1263 1264 -1260 48 1263 1265 -1261 48 1266 1267 -1262 48 1266 1268 -1263 48 1269 1270 -1264 48 1269 1271 -1265 48 1272 1273 -1266 48 1272 1274 -1267 48 1275 1276 -1268 48 1275 1277 -1269 48 1278 1279 -1270 48 1278 1280 -1271 48 1281 1282 -1272 48 1281 1283 -1273 48 1284 1285 -1274 48 1284 1286 -1275 48 1287 1288 -1276 48 1287 1289 -1277 48 1290 1291 -1278 48 1290 1292 -1279 48 1293 1294 -1280 48 1293 1295 -1281 48 1296 1297 -1282 48 1296 1298 -1283 48 1299 1300 -1284 48 1299 1301 -1285 48 1302 1303 -1286 48 1302 1304 -1287 48 1305 1306 -1288 48 1305 1307 -1289 48 1308 1309 -1290 48 1308 1310 -1291 48 1311 1312 -1292 48 1311 1313 -1293 48 1314 1315 -1294 48 1314 1316 -1295 48 1317 1318 -1296 48 1317 1319 -1297 48 1320 1321 -1298 48 1320 1322 -1299 48 1323 1324 -1300 48 1323 1325 -1301 48 1326 1327 -1302 48 1326 1328 -1303 48 1329 1330 -1304 48 1329 1331 -1305 48 1332 1333 -1306 48 1332 1334 -1307 48 1335 1336 -1308 48 1335 1337 -1309 48 1338 1339 -1310 48 1338 1340 -1311 48 1341 1342 -1312 48 1341 1343 -1313 48 1344 1345 -1314 48 1344 1346 -1315 48 1347 1348 -1316 48 1347 1349 -1317 48 1350 1351 -1318 48 1350 1352 -1319 48 1353 1354 -1320 48 1353 1355 -1321 48 1356 1357 -1322 48 1356 1358 -1323 48 1359 1360 -1324 48 1359 1361 -1325 48 1362 1363 -1326 48 1362 1364 -1327 48 1365 1366 -1328 48 1365 1367 -1329 48 1368 1369 -1330 48 1368 1370 -1331 48 1371 1372 -1332 48 1371 1373 -1333 48 1374 1375 -1334 48 1374 1376 -1335 48 1377 1378 -1336 48 1377 1379 -1337 48 1380 1381 -1338 48 1380 1382 -1339 48 1383 1384 -1340 48 1383 1385 -1341 48 1386 1387 -1342 48 1386 1388 -1343 48 1389 1390 -1344 48 1389 1391 -1345 48 1392 1393 -1346 48 1392 1394 -1347 48 1395 1396 -1348 48 1395 1397 -1349 48 1398 1399 -1350 48 1398 1400 -1351 48 1401 1402 -1352 48 1401 1403 -1353 48 1404 1405 -1354 48 1404 1406 -1355 48 1407 1408 -1356 48 1407 1409 -1357 48 1410 1411 -1358 48 1410 1412 -1359 48 1413 1414 -1360 48 1413 1415 -1361 48 1416 1417 -1362 48 1416 1418 -1363 48 1419 1420 -1364 48 1419 1421 -1365 48 1422 1423 -1366 48 1422 1424 -1367 48 1425 1426 -1368 48 1425 1427 -1369 48 1428 1429 -1370 48 1428 1430 -1371 48 1431 1432 -1372 48 1431 1433 -1373 48 1434 1435 -1374 48 1434 1436 -1375 48 1437 1438 -1376 48 1437 1439 -1377 48 1440 1441 -1378 48 1440 1442 -1379 48 1443 1444 -1380 48 1443 1445 -1381 48 1446 1447 -1382 48 1446 1448 -1383 48 1449 1450 -1384 48 1449 1451 -1385 48 1452 1453 -1386 48 1452 1454 -1387 48 1455 1456 -1388 48 1455 1457 -1389 48 1458 1459 -1390 48 1458 1460 -1391 48 1461 1462 -1392 48 1461 1463 -1393 48 1464 1465 -1394 48 1464 1466 -1395 48 1467 1468 -1396 48 1467 1469 -1397 48 1470 1471 -1398 48 1470 1472 -1399 48 1473 1474 -1400 48 1473 1475 -1401 48 1476 1477 -1402 48 1476 1478 -1403 48 1479 1480 -1404 48 1479 1481 -1405 48 1482 1483 -1406 48 1482 1484 -1407 48 1485 1486 -1408 48 1485 1487 -1409 48 1488 1489 -1410 48 1488 1490 -1411 48 1491 1492 -1412 48 1491 1493 -1413 48 1494 1495 -1414 48 1494 1496 -1415 48 1497 1498 -1416 48 1497 1499 -1417 48 1500 1501 -1418 48 1500 1502 -1419 48 1503 1504 -1420 48 1503 1505 -1421 48 1506 1507 -1422 48 1506 1508 -1423 48 1509 1510 -1424 48 1509 1511 -1425 48 1512 1513 -1426 48 1512 1514 -1427 48 1515 1516 -1428 48 1515 1517 -1429 48 1518 1519 -1430 48 1518 1520 -1431 48 1521 1522 -1432 48 1521 1523 -1433 48 1524 1525 -1434 48 1524 1526 -1435 48 1527 1528 -1436 48 1527 1529 -1437 48 1530 1531 -1438 48 1530 1532 -1439 48 1533 1534 -1440 48 1533 1535 -1441 48 1536 1537 -1442 48 1536 1538 -1443 48 1539 1540 -1444 48 1539 1541 -1445 48 1542 1543 -1446 48 1542 1544 -1447 48 1545 1546 -1448 48 1545 1547 -1449 48 1548 1549 -1450 48 1548 1550 -1451 48 1551 1552 -1452 48 1551 1553 -1453 48 1554 1555 -1454 48 1554 1556 -1455 48 1557 1558 -1456 48 1557 1559 -1457 48 1560 1561 -1458 48 1560 1562 -1459 48 1563 1564 -1460 48 1563 1565 -1461 48 1566 1567 -1462 48 1566 1568 -1463 48 1569 1570 -1464 48 1569 1571 -1465 48 1572 1573 -1466 48 1572 1574 -1467 48 1575 1576 -1468 48 1575 1577 -1469 48 1578 1579 -1470 48 1578 1580 -1471 48 1581 1582 -1472 48 1581 1583 -1473 48 1584 1585 -1474 48 1584 1586 -1475 48 1587 1588 -1476 48 1587 1589 -1477 48 1590 1591 -1478 48 1590 1592 -1479 48 1593 1594 -1480 48 1593 1595 -1481 48 1596 1597 -1482 48 1596 1598 -1483 48 1599 1600 -1484 48 1599 1601 -1485 48 1602 1603 -1486 48 1602 1604 -1487 48 1605 1606 -1488 48 1605 1607 -1489 48 1608 1609 -1490 48 1608 1610 -1491 48 1611 1612 -1492 48 1611 1613 -1493 48 1614 1615 -1494 48 1614 1616 -1495 48 1617 1618 -1496 48 1617 1619 -1497 48 1620 1621 -1498 48 1620 1622 -1499 48 1623 1624 -1500 48 1623 1625 -1501 48 1626 1627 -1502 48 1626 1628 -1503 48 1629 1630 -1504 48 1629 1631 -1505 48 1632 1633 -1506 48 1632 1634 -1507 48 1635 1636 -1508 48 1635 1637 -1509 48 1638 1639 -1510 48 1638 1640 -1511 48 1641 1642 -1512 48 1641 1643 -1513 48 1644 1645 -1514 48 1644 1646 -1515 48 1647 1648 -1516 48 1647 1649 -1517 48 1650 1651 -1518 48 1650 1652 -1519 48 1653 1654 -1520 48 1653 1655 -1521 48 1656 1657 -1522 48 1656 1658 -1523 48 1659 1660 -1524 48 1659 1661 -1525 48 1662 1663 -1526 48 1662 1664 -1527 48 1665 1666 -1528 48 1665 1667 -1529 48 1668 1669 -1530 48 1668 1670 -1531 48 1671 1672 -1532 48 1671 1673 -1533 48 1674 1675 -1534 48 1674 1676 -1535 48 1677 1678 -1536 48 1677 1679 -1537 48 1680 1681 -1538 48 1680 1682 -1539 48 1683 1684 -1540 48 1683 1685 -1541 48 1686 1687 -1542 48 1686 1688 -1543 48 1689 1690 -1544 48 1689 1691 -1545 48 1692 1693 -1546 48 1692 1694 -1547 48 1695 1696 -1548 48 1695 1697 -1549 48 1698 1699 -1550 48 1698 1700 -1551 48 1701 1702 -1552 48 1701 1703 -1553 48 1704 1705 -1554 48 1704 1706 -1555 48 1707 1708 -1556 48 1707 1709 -1557 48 1710 1711 -1558 48 1710 1712 -1559 48 1713 1714 -1560 48 1713 1715 -1561 48 1716 1717 -1562 48 1716 1718 -1563 48 1719 1720 -1564 48 1719 1721 -1565 48 1722 1723 -1566 48 1722 1724 -1567 48 1725 1726 -1568 48 1725 1727 -1569 48 1728 1729 -1570 48 1728 1730 -1571 48 1731 1732 -1572 48 1731 1733 -1573 48 1734 1735 -1574 48 1734 1736 -1575 48 1737 1738 -1576 48 1737 1739 -1577 48 1740 1741 -1578 48 1740 1742 -1579 48 1743 1744 -1580 48 1743 1745 -1581 48 1746 1747 -1582 48 1746 1748 -1583 48 1749 1750 -1584 48 1749 1751 -1585 48 1752 1753 -1586 48 1752 1754 -1587 48 1755 1756 -1588 48 1755 1757 -1589 48 1758 1759 -1590 48 1758 1760 -1591 48 1761 1762 -1592 48 1761 1763 -1593 48 1764 1765 -1594 48 1764 1766 -1595 48 1767 1768 -1596 48 1767 1769 -1597 48 1770 1771 -1598 48 1770 1772 -1599 48 1773 1774 -1600 48 1773 1775 -1601 48 1776 1777 -1602 48 1776 1778 -1603 48 1779 1780 -1604 48 1779 1781 -1605 48 1782 1783 -1606 48 1782 1784 -1607 48 1785 1786 -1608 48 1785 1787 -1609 48 1788 1789 -1610 48 1788 1790 -1611 48 1791 1792 -1612 48 1791 1793 -1613 48 1794 1795 -1614 48 1794 1796 -1615 48 1797 1798 -1616 48 1797 1799 -1617 48 1800 1801 -1618 48 1800 1802 -1619 48 1803 1804 -1620 48 1803 1805 -1621 48 1806 1807 -1622 48 1806 1808 -1623 48 1809 1810 -1624 48 1809 1811 -1625 48 1812 1813 -1626 48 1812 1814 -1627 48 1815 1816 -1628 48 1815 1817 -1629 48 1818 1819 -1630 48 1818 1820 -1631 48 1821 1822 -1632 48 1821 1823 -1633 48 1824 1825 -1634 48 1824 1826 -1635 48 1827 1828 -1636 48 1827 1829 -1637 48 1830 1831 -1638 48 1830 1832 -1639 48 1833 1834 -1640 48 1833 1835 -1641 48 1836 1837 -1642 48 1836 1838 -1643 48 1839 1840 -1644 48 1839 1841 -1645 48 1842 1843 -1646 48 1842 1844 -1647 48 1845 1846 -1648 48 1845 1847 -1649 48 1848 1849 -1650 48 1848 1850 -1651 48 1851 1852 -1652 48 1851 1853 -1653 48 1854 1855 -1654 48 1854 1856 -1655 48 1857 1858 -1656 48 1857 1859 -1657 48 1860 1861 -1658 48 1860 1862 -1659 48 1863 1864 -1660 48 1863 1865 -1661 48 1866 1867 -1662 48 1866 1868 -1663 48 1869 1870 -1664 48 1869 1871 -1665 48 1872 1873 -1666 48 1872 1874 -1667 48 1875 1876 -1668 48 1875 1877 -1669 48 1878 1879 -1670 48 1878 1880 -1671 48 1881 1882 -1672 48 1881 1883 -1673 48 1884 1885 -1674 48 1884 1886 -1675 48 1887 1888 -1676 48 1887 1889 -1677 48 1890 1891 -1678 48 1890 1892 -1679 48 1893 1894 -1680 48 1893 1895 -1681 48 1896 1897 -1682 48 1896 1898 -1683 48 1899 1900 -1684 48 1899 1901 -1685 48 1902 1903 -1686 48 1902 1904 -1687 48 1905 1906 -1688 48 1905 1907 -1689 48 1908 1909 -1690 48 1908 1910 -1691 48 1911 1912 -1692 48 1911 1913 -1693 48 1914 1915 -1694 48 1914 1916 -1695 48 1917 1918 -1696 48 1917 1919 -1697 48 1920 1921 -1698 48 1920 1922 -1699 48 1923 1924 -1700 48 1923 1925 -1701 48 1926 1927 -1702 48 1926 1928 -1703 48 1929 1930 -1704 48 1929 1931 -1705 48 1932 1933 -1706 48 1932 1934 -1707 48 1935 1936 -1708 48 1935 1937 -1709 48 1938 1939 -1710 48 1938 1940 -1711 48 1941 1942 -1712 48 1941 1943 -1713 48 1944 1945 -1714 48 1944 1946 -1715 48 1947 1948 -1716 48 1947 1949 -1717 48 1950 1951 -1718 48 1950 1952 -1719 48 1953 1954 -1720 48 1953 1955 -1721 48 1956 1957 -1722 48 1956 1958 -1723 48 1959 1960 -1724 48 1959 1961 -1725 48 1962 1963 -1726 48 1962 1964 -1727 48 1965 1966 -1728 48 1965 1967 -1729 48 1968 1969 -1730 48 1968 1970 -1731 48 1971 1972 -1732 48 1971 1973 -1733 48 1974 1975 -1734 48 1974 1976 -1735 48 1977 1978 -1736 48 1977 1979 -1737 48 1980 1981 -1738 48 1980 1982 -1739 48 1983 1984 -1740 48 1983 1985 -1741 48 1986 1987 -1742 48 1986 1988 -1743 48 1989 1990 -1744 48 1989 1991 -1745 48 1992 1993 -1746 48 1992 1994 -1747 48 1995 1996 -1748 48 1995 1997 -1749 48 1998 1999 -1750 48 1998 2000 -1751 48 2001 2002 -1752 48 2001 2003 -1753 48 2004 2005 -1754 48 2004 2006 -1755 48 2007 2008 -1756 48 2007 2009 -1757 48 2010 2011 -1758 48 2010 2012 -1759 48 2013 2014 -1760 48 2013 2015 -1761 48 2016 2017 -1762 48 2016 2018 -1763 48 2019 2020 -1764 48 2019 2021 -1765 48 2022 2023 -1766 48 2022 2024 -1767 48 2025 2026 -1768 48 2025 2027 -1769 48 2028 2029 -1770 48 2028 2030 -1771 48 2031 2032 -1772 48 2031 2033 -1773 48 2034 2035 -1774 48 2034 2036 -1775 48 2037 2038 -1776 48 2037 2039 -1777 48 2040 2041 -1778 48 2040 2042 -1779 48 2043 2044 -1780 48 2043 2045 -1781 48 2046 2047 -1782 48 2046 2048 -1783 48 2049 2050 -1784 48 2049 2051 -1785 48 2052 2053 -1786 48 2052 2054 -1787 48 2055 2056 -1788 48 2055 2057 -1789 48 2058 2059 -1790 48 2058 2060 -1791 48 2061 2062 -1792 48 2061 2063 -1793 48 2064 2065 -1794 48 2064 2066 -1795 48 2067 2068 -1796 48 2067 2069 -1797 48 2070 2071 -1798 48 2070 2072 -1799 48 2073 2074 -1800 48 2073 2075 -1801 48 2076 2077 -1802 48 2076 2078 -1803 48 2079 2080 -1804 48 2079 2081 -1805 48 2082 2083 -1806 48 2082 2084 -1807 48 2085 2086 -1808 48 2085 2087 -1809 48 2088 2089 -1810 48 2088 2090 -1811 48 2091 2092 -1812 48 2091 2093 -1813 48 2094 2095 -1814 48 2094 2096 -1815 48 2097 2098 -1816 48 2097 2099 -1817 48 2100 2101 -1818 48 2100 2102 -1819 48 2103 2104 -1820 48 2103 2105 -1821 48 2106 2107 -1822 48 2106 2108 -1823 48 2109 2110 -1824 48 2109 2111 -1825 48 2112 2113 -1826 48 2112 2114 -1827 48 2115 2116 -1828 48 2115 2117 -1829 48 2118 2119 -1830 48 2118 2120 -1831 48 2121 2122 -1832 48 2121 2123 -1833 48 2124 2125 -1834 48 2124 2126 -1835 48 2127 2128 -1836 48 2127 2129 -1837 48 2130 2131 -1838 48 2130 2132 -1839 48 2133 2134 -1840 48 2133 2135 -1841 48 2136 2137 -1842 48 2136 2138 -1843 48 2139 2140 -1844 48 2139 2141 -1845 48 2142 2143 -1846 48 2142 2144 -1847 48 2145 2146 -1848 48 2145 2147 -1849 48 2148 2149 -1850 48 2148 2150 -1851 48 2151 2152 -1852 48 2151 2153 -1853 48 2154 2155 -1854 48 2154 2156 -1855 48 2157 2158 -1856 48 2157 2159 -1857 48 2160 2161 -1858 48 2160 2162 -1859 48 2163 2164 -1860 48 2163 2165 -1861 48 2166 2167 -1862 48 2166 2168 -1863 48 2169 2170 -1864 48 2169 2171 -1865 48 2172 2173 -1866 48 2172 2174 -1867 48 2175 2176 -1868 48 2175 2177 -1869 48 2178 2179 -1870 48 2178 2180 -1871 48 2181 2182 -1872 48 2181 2183 -1873 48 2184 2185 -1874 48 2184 2186 -1875 48 2187 2188 -1876 48 2187 2189 -1877 48 2190 2191 -1878 48 2190 2192 -1879 48 2193 2194 -1880 48 2193 2195 -1881 48 2196 2197 -1882 48 2196 2198 -1883 48 2199 2200 -1884 48 2199 2201 -1885 48 2202 2203 -1886 48 2202 2204 -1887 48 2205 2206 -1888 48 2205 2207 -1889 48 2208 2209 -1890 48 2208 2210 -1891 48 2211 2212 -1892 48 2211 2213 -1893 48 2214 2215 -1894 48 2214 2216 -1895 48 2217 2218 -1896 48 2217 2219 -1897 48 2220 2221 -1898 48 2220 2222 -1899 48 2223 2224 -1900 48 2223 2225 -1901 48 2226 2227 -1902 48 2226 2228 -1903 48 2229 2230 -1904 48 2229 2231 -1905 48 2232 2233 -1906 48 2232 2234 -1907 48 2235 2236 -1908 48 2235 2237 -1909 48 2238 2239 -1910 48 2238 2240 -1911 48 2241 2242 -1912 48 2241 2243 -1913 48 2244 2245 -1914 48 2244 2246 -1915 48 2247 2248 -1916 48 2247 2249 -1917 48 2250 2251 -1918 48 2250 2252 -1919 48 2253 2254 -1920 48 2253 2255 -1921 48 2256 2257 -1922 48 2256 2258 -1923 48 2259 2260 -1924 48 2259 2261 -1925 48 2262 2263 -1926 48 2262 2264 -1927 48 2265 2266 -1928 48 2265 2267 -1929 48 2268 2269 -1930 48 2268 2270 -1931 48 2271 2272 -1932 48 2271 2273 -1933 48 2274 2275 -1934 48 2274 2276 -1935 48 2277 2278 -1936 48 2277 2279 -1937 48 2280 2281 -1938 48 2280 2282 -1939 48 2283 2284 -1940 48 2283 2285 -1941 48 2286 2287 -1942 48 2286 2288 -1943 48 2289 2290 -1944 48 2289 2291 -1945 48 2292 2293 -1946 48 2292 2294 -1947 48 2295 2296 -1948 48 2295 2297 -1949 48 2298 2299 -1950 48 2298 2300 -1951 48 2301 2302 -1952 48 2301 2303 -1953 48 2304 2305 -1954 48 2304 2306 -1955 48 2307 2308 -1956 48 2307 2309 -1957 48 2310 2311 -1958 48 2310 2312 -1959 48 2313 2314 -1960 48 2313 2315 -1961 48 2316 2317 -1962 48 2316 2318 -1963 48 2319 2320 -1964 48 2319 2321 -1965 48 2322 2323 -1966 48 2322 2324 -1967 48 2325 2326 -1968 48 2325 2327 -1969 48 2328 2329 -1970 48 2328 2330 -1971 48 2331 2332 -1972 48 2331 2333 -1973 48 2334 2335 -1974 48 2334 2336 -1975 48 2337 2338 -1976 48 2337 2339 -1977 48 2340 2341 -1978 48 2340 2342 -1979 48 2343 2344 -1980 48 2343 2345 -1981 48 2346 2347 -1982 48 2346 2348 -1983 48 2349 2350 -1984 48 2349 2351 -1985 48 2352 2353 -1986 48 2352 2354 -1987 48 2355 2356 -1988 48 2355 2357 -1989 48 2358 2359 -1990 48 2358 2360 -1991 48 2361 2362 -1992 48 2361 2363 -1993 48 2364 2365 -1994 48 2364 2366 -1995 48 2367 2368 -1996 48 2367 2369 -1997 48 2370 2371 -1998 48 2370 2372 -1999 48 2373 2374 -2000 48 2373 2375 -2001 48 2376 2377 -2002 48 2376 2378 -2003 48 2379 2380 -2004 48 2379 2381 -2005 48 2382 2383 -2006 48 2382 2384 -2007 48 2385 2386 -2008 48 2385 2387 -2009 48 2388 2389 -2010 48 2388 2390 -2011 48 2391 2392 -2012 48 2391 2393 -2013 48 2394 2395 -2014 48 2394 2396 -2015 48 2397 2398 -2016 48 2397 2399 -2017 48 2400 2401 -2018 48 2400 2402 -2019 48 2403 2404 -2020 48 2403 2405 -2021 48 2406 2407 -2022 48 2406 2408 -2023 48 2409 2410 -2024 48 2409 2411 -2025 48 2412 2413 -2026 48 2412 2414 -2027 48 2415 2416 -2028 48 2415 2417 -2029 48 2418 2419 -2030 48 2418 2420 -2031 48 2421 2422 -2032 48 2421 2423 -2033 48 2424 2425 -2034 48 2424 2426 -2035 48 2427 2428 -2036 48 2427 2429 -2037 48 2430 2431 -2038 48 2430 2432 -2039 48 2433 2434 -2040 48 2433 2435 -2041 48 2436 2437 -2042 48 2436 2438 -2043 48 2439 2440 -2044 48 2439 2441 -2045 48 2442 2443 -2046 48 2442 2444 -2047 48 2445 2446 -2048 48 2445 2447 -2049 48 2448 2449 -2050 48 2448 2450 -2051 48 2451 2452 -2052 48 2451 2453 -2053 48 2454 2455 -2054 48 2454 2456 -2055 48 2457 2458 -2056 48 2457 2459 -2057 48 2460 2461 -2058 48 2460 2462 -2059 48 2463 2464 -2060 48 2463 2465 -2061 48 2466 2467 -2062 48 2466 2468 -2063 48 2469 2470 -2064 48 2469 2471 -2065 48 2472 2473 -2066 48 2472 2474 -2067 48 2475 2476 -2068 48 2475 2477 -2069 48 2478 2479 -2070 48 2478 2480 -2071 48 2481 2482 -2072 48 2481 2483 -2073 48 2484 2485 -2074 48 2484 2486 -2075 48 2487 2488 -2076 48 2487 2489 -2077 48 2490 2491 -2078 48 2490 2492 -2079 48 2493 2494 -2080 48 2493 2495 -2081 48 2496 2497 -2082 48 2496 2498 -2083 48 2499 2500 -2084 48 2499 2501 -2085 48 2502 2503 -2086 48 2502 2504 -2087 48 2505 2506 -2088 48 2505 2507 -2089 48 2508 2509 -2090 48 2508 2510 -2091 48 2511 2512 -2092 48 2511 2513 -2093 48 2514 2515 -2094 48 2514 2516 -2095 48 2517 2518 -2096 48 2517 2519 -2097 48 2520 2521 -2098 48 2520 2522 -2099 48 2523 2524 -2100 48 2523 2525 -2101 48 2526 2527 -2102 48 2526 2528 -2103 48 2529 2530 -2104 48 2529 2531 -2105 48 2532 2533 -2106 48 2532 2534 -2107 48 2535 2536 -2108 48 2535 2537 -2109 48 2538 2539 -2110 48 2538 2540 -2111 48 2541 2542 -2112 48 2541 2543 -2113 48 2544 2545 -2114 48 2544 2546 -2115 48 2547 2548 -2116 48 2547 2549 -2117 48 2550 2551 -2118 48 2550 2552 -2119 48 2553 2554 -2120 48 2553 2555 -2121 48 2556 2557 -2122 48 2556 2558 -2123 48 2559 2560 -2124 48 2559 2561 -2125 48 2562 2563 -2126 48 2562 2564 -2127 48 2565 2566 -2128 48 2565 2567 -2129 48 2568 2569 -2130 48 2568 2570 -2131 48 2571 2572 -2132 48 2571 2573 -2133 48 2574 2575 -2134 48 2574 2576 -2135 48 2577 2578 -2136 48 2577 2579 -2137 48 2580 2581 -2138 48 2580 2582 -2139 48 2583 2584 -2140 48 2583 2585 -2141 48 2586 2587 -2142 48 2586 2588 -2143 48 2589 2590 -2144 48 2589 2591 -2145 48 2592 2593 -2146 48 2592 2594 -2147 48 2595 2596 -2148 48 2595 2597 -2149 48 2598 2599 -2150 48 2598 2600 -2151 48 2601 2602 -2152 48 2601 2603 -2153 48 2604 2605 -2154 48 2604 2606 -2155 48 2607 2608 -2156 48 2607 2609 -2157 48 2610 2611 -2158 48 2610 2612 -2159 48 2613 2614 -2160 48 2613 2615 -2161 48 2616 2617 -2162 48 2616 2618 -2163 48 2619 2620 -2164 48 2619 2621 -2165 48 2622 2623 -2166 48 2622 2624 -2167 48 2625 2626 -2168 48 2625 2627 -2169 48 2628 2629 -2170 48 2628 2630 -2171 48 2631 2632 -2172 48 2631 2633 -2173 48 2634 2635 -2174 48 2634 2636 -2175 48 2637 2638 -2176 48 2637 2639 -2177 48 2640 2641 -2178 48 2640 2642 -2179 48 2643 2644 -2180 48 2643 2645 -2181 48 2646 2647 -2182 48 2646 2648 -2183 48 2649 2650 -2184 48 2649 2651 -2185 48 2652 2653 -2186 48 2652 2654 -2187 48 2655 2656 -2188 48 2655 2657 -2189 48 2658 2659 -2190 48 2658 2660 -2191 48 2661 2662 -2192 48 2661 2663 -2193 48 2664 2665 -2194 48 2664 2666 -2195 48 2667 2668 -2196 48 2667 2669 -2197 48 2670 2671 -2198 48 2670 2672 -2199 48 2673 2674 -2200 48 2673 2675 -2201 48 2676 2677 -2202 48 2676 2678 -2203 48 2679 2680 -2204 48 2679 2681 -2205 48 2682 2683 -2206 48 2682 2684 -2207 48 2685 2686 -2208 48 2685 2687 -2209 48 2688 2689 -2210 48 2688 2690 -2211 48 2691 2692 -2212 48 2691 2693 -2213 48 2694 2695 -2214 48 2694 2696 -2215 48 2697 2698 -2216 48 2697 2699 -2217 48 2700 2701 -2218 48 2700 2702 -2219 48 2703 2704 -2220 48 2703 2705 -2221 48 2706 2707 -2222 48 2706 2708 -2223 48 2709 2710 -2224 48 2709 2711 -2225 48 2712 2713 -2226 48 2712 2714 -2227 48 2715 2716 -2228 48 2715 2717 -2229 48 2718 2719 -2230 48 2718 2720 -2231 48 2721 2722 -2232 48 2721 2723 -2233 48 2724 2725 -2234 48 2724 2726 -2235 48 2727 2728 -2236 48 2727 2729 -2237 48 2730 2731 -2238 48 2730 2732 -2239 48 2733 2734 -2240 48 2733 2735 -2241 48 2736 2737 -2242 48 2736 2738 -2243 48 2739 2740 -2244 48 2739 2741 -2245 48 2742 2743 -2246 48 2742 2744 -2247 48 2745 2746 -2248 48 2745 2747 -2249 48 2748 2749 -2250 48 2748 2750 -2251 48 2751 2752 -2252 48 2751 2753 -2253 48 2754 2755 -2254 48 2754 2756 -2255 48 2757 2758 -2256 48 2757 2759 -2257 48 2760 2761 -2258 48 2760 2762 -2259 48 2763 2764 -2260 48 2763 2765 -2261 48 2766 2767 -2262 48 2766 2768 -2263 48 2769 2770 -2264 48 2769 2771 -2265 48 2772 2773 -2266 48 2772 2774 -2267 48 2775 2776 -2268 48 2775 2777 -2269 48 2778 2779 -2270 48 2778 2780 -2271 48 2781 2782 -2272 48 2781 2783 -2273 48 2784 2785 -2274 48 2784 2786 -2275 48 2787 2788 -2276 48 2787 2789 -2277 48 2790 2791 -2278 48 2790 2792 -2279 48 2793 2794 -2280 48 2793 2795 -2281 48 2796 2797 -2282 48 2796 2798 -2283 48 2799 2800 -2284 48 2799 2801 -2285 48 2802 2803 -2286 48 2802 2804 -2287 48 2805 2806 -2288 48 2805 2807 -2289 48 2808 2809 -2290 48 2808 2810 -2291 48 2811 2812 -2292 48 2811 2813 -2293 48 2814 2815 -2294 48 2814 2816 -2295 48 2817 2818 -2296 48 2817 2819 -2297 48 2820 2821 -2298 48 2820 2822 -2299 48 2823 2824 -2300 48 2823 2825 -2301 48 2826 2827 -2302 48 2826 2828 -2303 48 2829 2830 -2304 48 2829 2831 -2305 48 2832 2833 -2306 48 2832 2834 -2307 48 2835 2836 -2308 48 2835 2837 -2309 48 2838 2839 -2310 48 2838 2840 -2311 48 2841 2842 -2312 48 2841 2843 -2313 48 2844 2845 -2314 48 2844 2846 -2315 48 2847 2848 -2316 48 2847 2849 -2317 48 2850 2851 -2318 48 2850 2852 -2319 48 2853 2854 -2320 48 2853 2855 -2321 48 2856 2857 -2322 48 2856 2858 -2323 48 2859 2860 -2324 48 2859 2861 -2325 48 2862 2863 -2326 48 2862 2864 -2327 48 2865 2866 -2328 48 2865 2867 -2329 48 2868 2869 -2330 48 2868 2870 -2331 48 2871 2872 -2332 48 2871 2873 -2333 48 2874 2875 -2334 48 2874 2876 -2335 48 2877 2878 -2336 48 2877 2879 -2337 48 2880 2881 -2338 48 2880 2882 -2339 48 2883 2884 -2340 48 2883 2885 -2341 48 2886 2887 -2342 48 2886 2888 -2343 48 2889 2890 -2344 48 2889 2891 -2345 48 2892 2893 -2346 48 2892 2894 -2347 48 2895 2896 -2348 48 2895 2897 -2349 48 2898 2899 -2350 48 2898 2900 -2351 48 2901 2902 -2352 48 2901 2903 -2353 48 2904 2905 -2354 48 2904 2906 -2355 48 2907 2908 -2356 48 2907 2909 -2357 48 2910 2911 -2358 48 2910 2912 -2359 48 2913 2914 -2360 48 2913 2915 -2361 48 2916 2917 -2362 48 2916 2918 -2363 48 2919 2920 -2364 48 2919 2921 -2365 48 2922 2923 -2366 48 2922 2924 -2367 48 2925 2926 -2368 48 2925 2927 -2369 48 2928 2929 -2370 48 2928 2930 -2371 48 2931 2932 -2372 48 2931 2933 -2373 48 2934 2935 -2374 48 2934 2936 -2375 48 2937 2938 -2376 48 2937 2939 -2377 48 2940 2941 -2378 48 2940 2942 -2379 48 2943 2944 -2380 48 2943 2945 -2381 48 2946 2947 -2382 48 2946 2948 -2383 48 2949 2950 -2384 48 2949 2951 -2385 48 2952 2953 -2386 48 2952 2954 -2387 48 2955 2956 -2388 48 2955 2957 -2389 48 2958 2959 -2390 48 2958 2960 -2391 48 2961 2962 -2392 48 2961 2963 -2393 48 2964 2965 -2394 48 2964 2966 -2395 48 2967 2968 -2396 48 2967 2969 -2397 48 2970 2971 -2398 48 2970 2972 -2399 48 2973 2974 -2400 48 2973 2975 -2401 48 2976 2977 -2402 48 2976 2978 -2403 48 2979 2980 -2404 48 2979 2981 -2405 48 2982 2983 -2406 48 2982 2984 -2407 48 2985 2986 -2408 48 2985 2987 -2409 48 2988 2989 -2410 48 2988 2990 -2411 48 2991 2992 -2412 48 2991 2993 -2413 48 2994 2995 -2414 48 2994 2996 -2415 48 2997 2998 -2416 48 2997 2999 -2417 48 3000 3001 -2418 48 3000 3002 -2419 48 3003 3004 -2420 48 3003 3005 -2421 48 3006 3007 -2422 48 3006 3008 -2423 48 3009 3010 -2424 48 3009 3011 -2425 48 3012 3013 -2426 48 3012 3014 -2427 48 3015 3016 -2428 48 3015 3017 -2429 48 3018 3019 -2430 48 3018 3020 -2431 48 3021 3022 -2432 48 3021 3023 -2433 48 3024 3025 -2434 48 3024 3026 -2435 48 3027 3028 -2436 48 3027 3029 -2437 48 3030 3031 -2438 48 3030 3032 -2439 48 3033 3034 -2440 48 3033 3035 -2441 48 3036 3037 -2442 48 3036 3038 -2443 48 3039 3040 -2444 48 3039 3041 -2445 48 3042 3043 -2446 48 3042 3044 -2447 48 3045 3046 -2448 48 3045 3047 -2449 48 3048 3049 -2450 48 3048 3050 -2451 48 3051 3052 -2452 48 3051 3053 -2453 48 3054 3055 -2454 48 3054 3056 -2455 48 3057 3058 -2456 48 3057 3059 -2457 48 3060 3061 -2458 48 3060 3062 -2459 48 3063 3064 -2460 48 3063 3065 -2461 48 3066 3067 -2462 48 3066 3068 -2463 48 3069 3070 -2464 48 3069 3071 -2465 48 3072 3073 -2466 48 3072 3074 -2467 48 3075 3076 -2468 48 3075 3077 -2469 48 3078 3079 -2470 48 3078 3080 -2471 48 3081 3082 -2472 48 3081 3083 -2473 48 3084 3085 -2474 48 3084 3086 -2475 48 3087 3088 -2476 48 3087 3089 -2477 48 3090 3091 -2478 48 3090 3092 -2479 48 3093 3094 -2480 48 3093 3095 -2481 48 3096 3097 -2482 48 3096 3098 -2483 48 3099 3100 -2484 48 3099 3101 -2485 48 3102 3103 -2486 48 3102 3104 -2487 48 3105 3106 -2488 48 3105 3107 -2489 48 3108 3109 -2490 48 3108 3110 -2491 48 3111 3112 -2492 48 3111 3113 -2493 48 3114 3115 -2494 48 3114 3116 -2495 48 3117 3118 -2496 48 3117 3119 -2497 48 3120 3121 -2498 48 3120 3122 -2499 48 3123 3124 -2500 48 3123 3125 -2501 48 3126 3127 -2502 48 3126 3128 -2503 48 3129 3130 -2504 48 3129 3131 -2505 48 3132 3133 -2506 48 3132 3134 -2507 48 3135 3136 -2508 48 3135 3137 -2509 48 3138 3139 -2510 48 3138 3140 -2511 48 3141 3142 -2512 48 3141 3143 -2513 48 3144 3145 -2514 48 3144 3146 -2515 48 3147 3148 -2516 48 3147 3149 -2517 48 3150 3151 -2518 48 3150 3152 -2519 48 3153 3154 -2520 48 3153 3155 -2521 48 3156 3157 -2522 48 3156 3158 -2523 48 3159 3160 -2524 48 3159 3161 -2525 48 3162 3163 -2526 48 3162 3164 -2527 48 3165 3166 -2528 48 3165 3167 -2529 48 3168 3169 -2530 48 3168 3170 -2531 48 3171 3172 -2532 48 3171 3173 -2533 48 3174 3175 -2534 48 3174 3176 -2535 48 3177 3178 -2536 48 3177 3179 -2537 48 3180 3181 -2538 48 3180 3182 -2539 48 3183 3184 -2540 48 3183 3185 -2541 48 3186 3187 -2542 48 3186 3188 -2543 48 3189 3190 -2544 48 3189 3191 -2545 48 3192 3193 -2546 48 3192 3194 -2547 48 3195 3196 -2548 48 3195 3197 -2549 48 3198 3199 -2550 48 3198 3200 -2551 48 3201 3202 -2552 48 3201 3203 -2553 48 3204 3205 -2554 48 3204 3206 -2555 48 3207 3208 -2556 48 3207 3209 -2557 48 3210 3211 -2558 48 3210 3212 -2559 48 3213 3214 -2560 48 3213 3215 -2561 48 3216 3217 -2562 48 3216 3218 -2563 48 3219 3220 -2564 48 3219 3221 -2565 48 3222 3223 -2566 48 3222 3224 -2567 48 3225 3226 -2568 48 3225 3227 -2569 48 3228 3229 -2570 48 3228 3230 -2571 48 3231 3232 -2572 48 3231 3233 -2573 48 3234 3235 -2574 48 3234 3236 -2575 48 3237 3238 -2576 48 3237 3239 -2577 48 3240 3241 -2578 48 3240 3242 -2579 48 3243 3244 -2580 48 3243 3245 -2581 48 3246 3247 -2582 48 3246 3248 -2583 48 3249 3250 -2584 48 3249 3251 -2585 48 3252 3253 -2586 48 3252 3254 -2587 48 3255 3256 -2588 48 3255 3257 -2589 48 3258 3259 -2590 48 3258 3260 -2591 48 3261 3262 -2592 48 3261 3263 -2593 48 3264 3265 -2594 48 3264 3266 -2595 48 3267 3268 -2596 48 3267 3269 -2597 48 3270 3271 -2598 48 3270 3272 -2599 48 3273 3274 -2600 48 3273 3275 -2601 48 3276 3277 -2602 48 3276 3278 -2603 48 3279 3280 -2604 48 3279 3281 -2605 48 3282 3283 -2606 48 3282 3284 -2607 48 3285 3286 -2608 48 3285 3287 -2609 48 3288 3289 -2610 48 3288 3290 -2611 48 3291 3292 -2612 48 3291 3293 -2613 48 3294 3295 -2614 48 3294 3296 -2615 48 3297 3298 -2616 48 3297 3299 -2617 48 3300 3301 -2618 48 3300 3302 -2619 48 3303 3304 -2620 48 3303 3305 -2621 48 3306 3307 -2622 48 3306 3308 -2623 48 3309 3310 -2624 48 3309 3311 -2625 48 3312 3313 -2626 48 3312 3314 -2627 48 3315 3316 -2628 48 3315 3317 -2629 48 3318 3319 -2630 48 3318 3320 -2631 48 3321 3322 -2632 48 3321 3323 -2633 48 3324 3325 -2634 48 3324 3326 -2635 48 3327 3328 -2636 48 3327 3329 -2637 48 3330 3331 -2638 48 3330 3332 -2639 48 3333 3334 -2640 48 3333 3335 -2641 48 3336 3337 -2642 48 3336 3338 -2643 48 3339 3340 -2644 48 3339 3341 -2645 48 3342 3343 -2646 48 3342 3344 -2647 48 3345 3346 -2648 48 3345 3347 -2649 48 3348 3349 -2650 48 3348 3350 -2651 48 3351 3352 -2652 48 3351 3353 -2653 48 3354 3355 -2654 48 3354 3356 -2655 48 3357 3358 -2656 48 3357 3359 -2657 48 3360 3361 -2658 48 3360 3362 -2659 48 3363 3364 -2660 48 3363 3365 -2661 48 3366 3367 -2662 48 3366 3368 -2663 48 3369 3370 -2664 48 3369 3371 -2665 48 3372 3373 -2666 48 3372 3374 -2667 48 3375 3376 -2668 48 3375 3377 -2669 48 3378 3379 -2670 48 3378 3380 -2671 48 3381 3382 -2672 48 3381 3383 -2673 48 3384 3385 -2674 48 3384 3386 -2675 48 3387 3388 -2676 48 3387 3389 -2677 48 3390 3391 -2678 48 3390 3392 -2679 48 3393 3394 -2680 48 3393 3395 -2681 48 3396 3397 -2682 48 3396 3398 -2683 48 3399 3400 -2684 48 3399 3401 -2685 48 3402 3403 -2686 48 3402 3404 -2687 48 3405 3406 -2688 48 3405 3407 -2689 48 3408 3409 -2690 48 3408 3410 -2691 48 3411 3412 -2692 48 3411 3413 -2693 48 3414 3415 -2694 48 3414 3416 -2695 48 3417 3418 -2696 48 3417 3419 -2697 48 3420 3421 -2698 48 3420 3422 -2699 48 3423 3424 -2700 48 3423 3425 -2701 48 3426 3427 -2702 48 3426 3428 -2703 48 3429 3430 -2704 48 3429 3431 -2705 48 3432 3433 -2706 48 3432 3434 -2707 48 3435 3436 -2708 48 3435 3437 -2709 48 3438 3439 -2710 48 3438 3440 -2711 48 3441 3442 -2712 48 3441 3443 -2713 48 3444 3445 -2714 48 3444 3446 -2715 48 3447 3448 -2716 48 3447 3449 -2717 48 3450 3451 -2718 48 3450 3452 -2719 48 3453 3454 -2720 48 3453 3455 -2721 48 3456 3457 -2722 48 3456 3458 -2723 48 3459 3460 -2724 48 3459 3461 -2725 48 3462 3463 -2726 48 3462 3464 -2727 48 3465 3466 -2728 48 3465 3467 -2729 48 3468 3469 -2730 48 3468 3470 -2731 48 3471 3472 -2732 48 3471 3473 -2733 48 3474 3475 -2734 48 3474 3476 -2735 48 3477 3478 -2736 48 3477 3479 -2737 48 3480 3481 -2738 48 3480 3482 -2739 48 3483 3484 -2740 48 3483 3485 -2741 48 3486 3487 -2742 48 3486 3488 -2743 48 3489 3490 -2744 48 3489 3491 -2745 48 3492 3493 -2746 48 3492 3494 -2747 48 3495 3496 -2748 48 3495 3497 -2749 48 3498 3499 -2750 48 3498 3500 -2751 48 3501 3502 -2752 48 3501 3503 -2753 48 3504 3505 -2754 48 3504 3506 -2755 48 3507 3508 -2756 48 3507 3509 -2757 48 3510 3511 -2758 48 3510 3512 -2759 48 3513 3514 -2760 48 3513 3515 -2761 48 3516 3517 -2762 48 3516 3518 -2763 48 3519 3520 -2764 48 3519 3521 -2765 48 3522 3523 -2766 48 3522 3524 -2767 48 3525 3526 -2768 48 3525 3527 -2769 48 3528 3529 -2770 48 3528 3530 -2771 48 3531 3532 -2772 48 3531 3533 -2773 48 3534 3535 -2774 48 3534 3536 -2775 48 3537 3538 -2776 48 3537 3539 -2777 48 3540 3541 -2778 48 3540 3542 -2779 48 3543 3544 -2780 48 3543 3545 -2781 48 3546 3547 -2782 48 3546 3548 -2783 48 3549 3550 -2784 48 3549 3551 -2785 48 3552 3553 -2786 48 3552 3554 -2787 48 3555 3556 -2788 48 3555 3557 -2789 48 3558 3559 -2790 48 3558 3560 -2791 48 3561 3562 -2792 48 3561 3563 -2793 48 3564 3565 -2794 48 3564 3566 -2795 48 3567 3568 -2796 48 3567 3569 -2797 48 3570 3571 -2798 48 3570 3572 -2799 48 3573 3574 -2800 48 3573 3575 -2801 48 3576 3577 -2802 48 3576 3578 -2803 48 3579 3580 -2804 48 3579 3581 -2805 48 3582 3583 -2806 48 3582 3584 -2807 48 3585 3586 -2808 48 3585 3587 -2809 48 3588 3589 -2810 48 3588 3590 -2811 48 3591 3592 -2812 48 3591 3593 -2813 48 3594 3595 -2814 48 3594 3596 -2815 48 3597 3598 -2816 48 3597 3599 -2817 48 3600 3601 -2818 48 3600 3602 -2819 48 3603 3604 -2820 48 3603 3605 -2821 48 3606 3607 -2822 48 3606 3608 -2823 48 3609 3610 -2824 48 3609 3611 -2825 48 3612 3613 -2826 48 3612 3614 -2827 48 3615 3616 -2828 48 3615 3617 -2829 48 3618 3619 -2830 48 3618 3620 -2831 48 3621 3622 -2832 48 3621 3623 -2833 48 3624 3625 -2834 48 3624 3626 -2835 48 3627 3628 -2836 48 3627 3629 -2837 48 3630 3631 -2838 48 3630 3632 -2839 48 3633 3634 -2840 48 3633 3635 -2841 48 3636 3637 -2842 48 3636 3638 -2843 48 3639 3640 -2844 48 3639 3641 -2845 48 3642 3643 -2846 48 3642 3644 -2847 48 3645 3646 -2848 48 3645 3647 -2849 48 3648 3649 -2850 48 3648 3650 -2851 48 3651 3652 -2852 48 3651 3653 -2853 48 3654 3655 -2854 48 3654 3656 -2855 48 3657 3658 -2856 48 3657 3659 -2857 48 3660 3661 -2858 48 3660 3662 -2859 48 3663 3664 -2860 48 3663 3665 -2861 48 3666 3667 -2862 48 3666 3668 -2863 48 3669 3670 -2864 48 3669 3671 -2865 48 3672 3673 -2866 48 3672 3674 -2867 48 3675 3676 -2868 48 3675 3677 -2869 48 3678 3679 -2870 48 3678 3680 -2871 48 3681 3682 -2872 48 3681 3683 -2873 48 3684 3685 -2874 48 3684 3686 -2875 48 3687 3688 -2876 48 3687 3689 -2877 48 3690 3691 -2878 48 3690 3692 -2879 48 3693 3694 -2880 48 3693 3695 -2881 48 3696 3697 -2882 48 3696 3698 -2883 48 3699 3700 -2884 48 3699 3701 -2885 48 3702 3703 -2886 48 3702 3704 -2887 48 3705 3706 -2888 48 3705 3707 -2889 48 3708 3709 -2890 48 3708 3710 -2891 48 3711 3712 -2892 48 3711 3713 -2893 48 3714 3715 -2894 48 3714 3716 -2895 48 3717 3718 -2896 48 3717 3719 -2897 48 3720 3721 -2898 48 3720 3722 -2899 48 3723 3724 -2900 48 3723 3725 -2901 48 3726 3727 -2902 48 3726 3728 -2903 48 3729 3730 -2904 48 3729 3731 -2905 48 3732 3733 -2906 48 3732 3734 -2907 48 3735 3736 -2908 48 3735 3737 -2909 48 3738 3739 -2910 48 3738 3740 -2911 48 3741 3742 -2912 48 3741 3743 -2913 48 3744 3745 -2914 48 3744 3746 -2915 48 3747 3748 -2916 48 3747 3749 -2917 48 3750 3751 -2918 48 3750 3752 -2919 48 3753 3754 -2920 48 3753 3755 -2921 48 3756 3757 -2922 48 3756 3758 -2923 48 3759 3760 -2924 48 3759 3761 -2925 48 3762 3763 -2926 48 3762 3764 -2927 48 3765 3766 -2928 48 3765 3767 -2929 48 3768 3769 -2930 48 3768 3770 -2931 48 3771 3772 -2932 48 3771 3773 -2933 48 3774 3775 -2934 48 3774 3776 -2935 48 3777 3778 -2936 48 3777 3779 -2937 48 3780 3781 -2938 48 3780 3782 -2939 48 3783 3784 -2940 48 3783 3785 -2941 48 3786 3787 -2942 48 3786 3788 -2943 48 3789 3790 -2944 48 3789 3791 -2945 48 3792 3793 -2946 48 3792 3794 -2947 48 3795 3796 -2948 48 3795 3797 -2949 48 3798 3799 -2950 48 3798 3800 -2951 48 3801 3802 -2952 48 3801 3803 -2953 48 3804 3805 -2954 48 3804 3806 -2955 48 3807 3808 -2956 48 3807 3809 -2957 48 3810 3811 -2958 48 3810 3812 -2959 48 3813 3814 -2960 48 3813 3815 -2961 48 3816 3817 -2962 48 3816 3818 -2963 48 3819 3820 -2964 48 3819 3821 -2965 48 3822 3823 -2966 48 3822 3824 -2967 48 3825 3826 -2968 48 3825 3827 -2969 48 3828 3829 -2970 48 3828 3830 -2971 48 3831 3832 -2972 48 3831 3833 -2973 48 3834 3835 -2974 48 3834 3836 -2975 48 3837 3838 -2976 48 3837 3839 -2977 48 3840 3841 -2978 48 3840 3842 -2979 48 3843 3844 -2980 48 3843 3845 -2981 48 3846 3847 -2982 48 3846 3848 -2983 48 3849 3850 -2984 48 3849 3851 -2985 48 3852 3853 -2986 48 3852 3854 -2987 48 3855 3856 -2988 48 3855 3857 -2989 48 3858 3859 -2990 48 3858 3860 -2991 48 3861 3862 -2992 48 3861 3863 -2993 48 3864 3865 -2994 48 3864 3866 -2995 48 3867 3868 -2996 48 3867 3869 -2997 48 3870 3871 -2998 48 3870 3872 -2999 48 3873 3874 -3000 48 3873 3875 -3001 48 3876 3877 -3002 48 3876 3878 -3003 48 3879 3880 -3004 48 3879 3881 -3005 48 3882 3883 -3006 48 3882 3884 -3007 48 3885 3886 -3008 48 3885 3887 -3009 48 3888 3889 -3010 48 3888 3890 -3011 48 3891 3892 -3012 48 3891 3893 -3013 48 3894 3895 -3014 48 3894 3896 -3015 48 3897 3898 -3016 48 3897 3899 -3017 48 3900 3901 -3018 48 3900 3902 -3019 48 3903 3904 -3020 48 3903 3905 -3021 48 3906 3907 -3022 48 3906 3908 -3023 48 3909 3910 -3024 48 3909 3911 -3025 48 3912 3913 -3026 48 3912 3914 -3027 48 3915 3916 -3028 48 3915 3917 -3029 48 3918 3919 -3030 48 3918 3920 -3031 48 3921 3922 -3032 48 3921 3923 -3033 48 3924 3925 -3034 48 3924 3926 -3035 48 3927 3928 -3036 48 3927 3929 -3037 48 3930 3931 -3038 48 3930 3932 -3039 48 3933 3934 -3040 48 3933 3935 -3041 48 3936 3937 -3042 48 3936 3938 -3043 48 3939 3940 -3044 48 3939 3941 -3045 48 3942 3943 -3046 48 3942 3944 -3047 48 3945 3946 -3048 48 3945 3947 -3049 48 3948 3949 -3050 48 3948 3950 -3051 48 3951 3952 -3052 48 3951 3953 -3053 48 3954 3955 -3054 48 3954 3956 -3055 48 3957 3958 -3056 48 3957 3959 -3057 48 3960 3961 -3058 48 3960 3962 -3059 48 3963 3964 -3060 48 3963 3965 -3061 48 3966 3967 -3062 48 3966 3968 -3063 48 3969 3970 -3064 48 3969 3971 -3065 48 3972 3973 -3066 48 3972 3974 -3067 48 3975 3976 -3068 48 3975 3977 -3069 48 3978 3979 -3070 48 3978 3980 -3071 48 3981 3982 -3072 48 3981 3983 -3073 48 3984 3985 -3074 48 3984 3986 -3075 48 3987 3988 -3076 48 3987 3989 -3077 48 3990 3991 -3078 48 3990 3992 -3079 48 3993 3994 -3080 48 3993 3995 -3081 48 3996 3997 -3082 48 3996 3998 -3083 48 3999 4000 -3084 48 3999 4001 -3085 48 4002 4003 -3086 48 4002 4004 -3087 48 4005 4006 -3088 48 4005 4007 -3089 48 4008 4009 -3090 48 4008 4010 -3091 48 4011 4012 -3092 48 4011 4013 -3093 48 4014 4015 -3094 48 4014 4016 -3095 48 4017 4018 -3096 48 4017 4019 -3097 48 4020 4021 -3098 48 4020 4022 -3099 48 4023 4024 -3100 48 4023 4025 -3101 48 4026 4027 -3102 48 4026 4028 -3103 48 4029 4030 -3104 48 4029 4031 -3105 48 4032 4033 -3106 48 4032 4034 -3107 48 4035 4036 -3108 48 4035 4037 -3109 48 4038 4039 -3110 48 4038 4040 -3111 48 4041 4042 -3112 48 4041 4043 -3113 48 4044 4045 -3114 48 4044 4046 -3115 48 4047 4048 -3116 48 4047 4049 -3117 48 4050 4051 -3118 48 4050 4052 -3119 48 4053 4054 -3120 48 4053 4055 -3121 48 4056 4057 -3122 48 4056 4058 -3123 48 4059 4060 -3124 48 4059 4061 -3125 48 4062 4063 -3126 48 4062 4064 -3127 48 4065 4066 -3128 48 4065 4067 -3129 48 4068 4069 -3130 48 4068 4070 -3131 48 4071 4072 -3132 48 4071 4073 -3133 48 4074 4075 -3134 48 4074 4076 -3135 48 4077 4078 -3136 48 4077 4079 -3137 48 4080 4081 -3138 48 4080 4082 -3139 48 4083 4084 -3140 48 4083 4085 -3141 48 4086 4087 -3142 48 4086 4088 -3143 48 4089 4090 -3144 48 4089 4091 -3145 48 4092 4093 -3146 48 4092 4094 -3147 48 4095 4096 -3148 48 4095 4097 -3149 48 4098 4099 -3150 48 4098 4100 -3151 48 4101 4102 -3152 48 4101 4103 -3153 48 4104 4105 -3154 48 4104 4106 -3155 48 4107 4108 -3156 48 4107 4109 -3157 48 4110 4111 -3158 48 4110 4112 -3159 48 4113 4114 -3160 48 4113 4115 -3161 48 4116 4117 -3162 48 4116 4118 -3163 48 4119 4120 -3164 48 4119 4121 -3165 48 4122 4123 -3166 48 4122 4124 -3167 48 4125 4126 -3168 48 4125 4127 -3169 48 4128 4129 -3170 48 4128 4130 -3171 48 4131 4132 -3172 48 4131 4133 -3173 48 4134 4135 -3174 48 4134 4136 -3175 48 4137 4138 -3176 48 4137 4139 -3177 48 4140 4141 -3178 48 4140 4142 -3179 48 4143 4144 -3180 48 4143 4145 -3181 48 4146 4147 -3182 48 4146 4148 -3183 48 4149 4150 -3184 48 4149 4151 -3185 48 4152 4153 -3186 48 4152 4154 -3187 48 4155 4156 -3188 48 4155 4157 -3189 48 4158 4159 -3190 48 4158 4160 -3191 48 4161 4162 -3192 48 4161 4163 -3193 48 4164 4165 -3194 48 4164 4166 -3195 48 4167 4168 -3196 48 4167 4169 -3197 48 4170 4171 -3198 48 4170 4172 -3199 48 4173 4174 -3200 48 4173 4175 -3201 48 4176 4177 -3202 48 4176 4178 -3203 48 4179 4180 -3204 48 4179 4181 -3205 48 4182 4183 -3206 48 4182 4184 -3207 48 4185 4186 -3208 48 4185 4187 -3209 48 4188 4189 -3210 48 4188 4190 -3211 48 4191 4192 -3212 48 4191 4193 -3213 48 4194 4195 -3214 48 4194 4196 -3215 48 4197 4198 -3216 48 4197 4199 -3217 48 4200 4201 -3218 48 4200 4202 -3219 48 4203 4204 -3220 48 4203 4205 -3221 48 4206 4207 -3222 48 4206 4208 -3223 48 4209 4210 -3224 48 4209 4211 -3225 48 4212 4213 -3226 48 4212 4214 -3227 48 4215 4216 -3228 48 4215 4217 -3229 48 4218 4219 -3230 48 4218 4220 -3231 48 4221 4222 -3232 48 4221 4223 -3233 48 4224 4225 -3234 48 4224 4226 -3235 48 4227 4228 -3236 48 4227 4229 -3237 48 4230 4231 -3238 48 4230 4232 -3239 48 4233 4234 -3240 48 4233 4235 -3241 48 4236 4237 -3242 48 4236 4238 -3243 48 4239 4240 -3244 48 4239 4241 -3245 48 4242 4243 -3246 48 4242 4244 -3247 48 4245 4246 -3248 48 4245 4247 -3249 48 4248 4249 -3250 48 4248 4250 -3251 48 4251 4252 -3252 48 4251 4253 -3253 48 4254 4255 -3254 48 4254 4256 -3255 48 4257 4258 -3256 48 4257 4259 -3257 48 4260 4261 -3258 48 4260 4262 -3259 48 4263 4264 -3260 48 4263 4265 -3261 48 4266 4267 -3262 48 4266 4268 -3263 48 4269 4270 -3264 48 4269 4271 -3265 48 4272 4273 -3266 48 4272 4274 -3267 48 4275 4276 -3268 48 4275 4277 -3269 48 4278 4279 -3270 48 4278 4280 -3271 48 4281 4282 -3272 48 4281 4283 -3273 48 4284 4285 -3274 48 4284 4286 -3275 48 4287 4288 -3276 48 4287 4289 -3277 48 4290 4291 -3278 48 4290 4292 -3279 48 4293 4294 -3280 48 4293 4295 -3281 48 4296 4297 -3282 48 4296 4298 -3283 48 4299 4300 -3284 48 4299 4301 -3285 48 4302 4303 -3286 48 4302 4304 -3287 48 4305 4306 -3288 48 4305 4307 -3289 48 4308 4309 -3290 48 4308 4310 -3291 48 4311 4312 -3292 48 4311 4313 -3293 48 4314 4315 -3294 48 4314 4316 -3295 48 4317 4318 -3296 48 4317 4319 -3297 48 4320 4321 -3298 48 4320 4322 -3299 48 4323 4324 -3300 48 4323 4325 -3301 48 4326 4327 -3302 48 4326 4328 -3303 48 4329 4330 -3304 48 4329 4331 -3305 48 4332 4333 -3306 48 4332 4334 -3307 48 4335 4336 -3308 48 4335 4337 -3309 48 4338 4339 -3310 48 4338 4340 -3311 48 4341 4342 -3312 48 4341 4343 -3313 48 4344 4345 -3314 48 4344 4346 -3315 48 4347 4348 -3316 48 4347 4349 -3317 48 4350 4351 -3318 48 4350 4352 -3319 48 4353 4354 -3320 48 4353 4355 -3321 48 4356 4357 -3322 48 4356 4358 -3323 48 4359 4360 -3324 48 4359 4361 -3325 48 4362 4363 -3326 48 4362 4364 -3327 48 4365 4366 -3328 48 4365 4367 -3329 48 4368 4369 -3330 48 4368 4370 -3331 48 4371 4372 -3332 48 4371 4373 -3333 48 4374 4375 -3334 48 4374 4376 -3335 48 4377 4378 -3336 48 4377 4379 -3337 48 4380 4381 -3338 48 4380 4382 -3339 48 4383 4384 -3340 48 4383 4385 -3341 48 4386 4387 -3342 48 4386 4388 -3343 48 4389 4390 -3344 48 4389 4391 -3345 48 4392 4393 -3346 48 4392 4394 -3347 48 4395 4396 -3348 48 4395 4397 -3349 48 4398 4399 -3350 48 4398 4400 -3351 48 4401 4402 -3352 48 4401 4403 -3353 48 4404 4405 -3354 48 4404 4406 -3355 48 4407 4408 -3356 48 4407 4409 -3357 48 4410 4411 -3358 48 4410 4412 -3359 48 4413 4414 -3360 48 4413 4415 -3361 48 4416 4417 -3362 48 4416 4418 -3363 48 4419 4420 -3364 48 4419 4421 -3365 48 4422 4423 -3366 48 4422 4424 -3367 48 4425 4426 -3368 48 4425 4427 -3369 48 4428 4429 -3370 48 4428 4430 -3371 48 4431 4432 -3372 48 4431 4433 -3373 48 4434 4435 -3374 48 4434 4436 -3375 48 4437 4438 -3376 48 4437 4439 -3377 48 4440 4441 -3378 48 4440 4442 -3379 48 4443 4444 -3380 48 4443 4445 -3381 48 4446 4447 -3382 48 4446 4448 -3383 48 4449 4450 -3384 48 4449 4451 -3385 48 4452 4453 -3386 48 4452 4454 -3387 48 4455 4456 -3388 48 4455 4457 -3389 48 4458 4459 -3390 48 4458 4460 -3391 48 4461 4462 -3392 48 4461 4463 -3393 48 4464 4465 -3394 48 4464 4466 -3395 48 4467 4468 -3396 48 4467 4469 -3397 48 4470 4471 -3398 48 4470 4472 -3399 48 4473 4474 -3400 48 4473 4475 -3401 48 4476 4477 -3402 48 4476 4478 -3403 48 4479 4480 -3404 48 4479 4481 -3405 48 4482 4483 -3406 48 4482 4484 -3407 48 4485 4486 -3408 48 4485 4487 -3409 48 4488 4489 -3410 48 4488 4490 -3411 48 4491 4492 -3412 48 4491 4493 -3413 48 4494 4495 -3414 48 4494 4496 -3415 48 4497 4498 -3416 48 4497 4499 -3417 48 4500 4501 -3418 48 4500 4502 -3419 48 4503 4504 -3420 48 4503 4505 -3421 48 4506 4507 -3422 48 4506 4508 -3423 48 4509 4510 -3424 48 4509 4511 -3425 48 4512 4513 -3426 48 4512 4514 -3427 48 4515 4516 -3428 48 4515 4517 -3429 48 4518 4519 -3430 48 4518 4520 -3431 48 4521 4522 -3432 48 4521 4523 -3433 48 4524 4525 -3434 48 4524 4526 -3435 48 4527 4528 -3436 48 4527 4529 -3437 48 4530 4531 -3438 48 4530 4532 -3439 48 4533 4534 -3440 48 4533 4535 -3441 48 4536 4537 -3442 48 4536 4538 -3443 48 4539 4540 -3444 48 4539 4541 -3445 48 4542 4543 -3446 48 4542 4544 -3447 48 4545 4546 -3448 48 4545 4547 -3449 48 4548 4549 -3450 48 4548 4550 -3451 48 4551 4552 -3452 48 4551 4553 -3453 48 4554 4555 -3454 48 4554 4556 -3455 48 4557 4558 -3456 48 4557 4559 -3457 48 4560 4561 -3458 48 4560 4562 -3459 48 4563 4564 -3460 48 4563 4565 -3461 48 4566 4567 -3462 48 4566 4568 -3463 48 4569 4570 -3464 48 4569 4571 -3465 48 4572 4573 -3466 48 4572 4574 -3467 48 4575 4576 -3468 48 4575 4577 -3469 48 4578 4579 -3470 48 4578 4580 -3471 48 4581 4582 -3472 48 4581 4583 -3473 48 4584 4585 -3474 48 4584 4586 -3475 48 4587 4588 -3476 48 4587 4589 -3477 48 4590 4591 -3478 48 4590 4592 -3479 48 4593 4594 -3480 48 4593 4595 -3481 48 4596 4597 -3482 48 4596 4598 -3483 48 4599 4600 -3484 48 4599 4601 -3485 48 4602 4603 -3486 48 4602 4604 -3487 48 4605 4606 -3488 48 4605 4607 -3489 48 4608 4609 -3490 48 4608 4610 -3491 48 4611 4612 -3492 48 4611 4613 -3493 48 4614 4615 -3494 48 4614 4616 -3495 48 4617 4618 -3496 48 4617 4619 -3497 48 4620 4621 -3498 48 4620 4622 -3499 48 4623 4624 -3500 48 4623 4625 -3501 48 4626 4627 -3502 48 4626 4628 -3503 48 4629 4630 -3504 48 4629 4631 -3505 48 4632 4633 -3506 48 4632 4634 -3507 48 4635 4636 -3508 48 4635 4637 -3509 48 4638 4639 -3510 48 4638 4640 -3511 48 4641 4642 -3512 48 4641 4643 -3513 48 4644 4645 -3514 48 4644 4646 -3515 48 4647 4648 -3516 48 4647 4649 -3517 48 4650 4651 -3518 48 4650 4652 -3519 48 4653 4654 -3520 48 4653 4655 -3521 48 4656 4657 -3522 48 4656 4658 -3523 48 4659 4660 -3524 48 4659 4661 -3525 48 4662 4663 -3526 48 4662 4664 -3527 48 4665 4666 -3528 48 4665 4667 -3529 48 4668 4669 -3530 48 4668 4670 -3531 48 4671 4672 -3532 48 4671 4673 -3533 48 4674 4675 -3534 48 4674 4676 -3535 48 4677 4678 -3536 48 4677 4679 -3537 48 4680 4681 -3538 48 4680 4682 -3539 48 4683 4684 -3540 48 4683 4685 -3541 48 4686 4687 -3542 48 4686 4688 -3543 48 4689 4690 -3544 48 4689 4691 -3545 48 4692 4693 -3546 48 4692 4694 -3547 48 4695 4696 -3548 48 4695 4697 -3549 48 4698 4699 -3550 48 4698 4700 -3551 48 4701 4702 -3552 48 4701 4703 -3553 48 4704 4705 -3554 48 4704 4706 -3555 48 4707 4708 -3556 48 4707 4709 -3557 48 4710 4711 -3558 48 4710 4712 -3559 48 4713 4714 -3560 48 4713 4715 -3561 48 4716 4717 -3562 48 4716 4718 -3563 48 4719 4720 -3564 48 4719 4721 -3565 48 4722 4723 -3566 48 4722 4724 -3567 48 4725 4726 -3568 48 4725 4727 -3569 48 4728 4729 -3570 48 4728 4730 -3571 48 4731 4732 -3572 48 4731 4733 -3573 48 4734 4735 -3574 48 4734 4736 -3575 48 4737 4738 -3576 48 4737 4739 -3577 48 4740 4741 -3578 48 4740 4742 -3579 48 4743 4744 -3580 48 4743 4745 -3581 48 4746 4747 -3582 48 4746 4748 -3583 48 4749 4750 -3584 48 4749 4751 -3585 48 4752 4753 -3586 48 4752 4754 -3587 48 4755 4756 -3588 48 4755 4757 -3589 48 4758 4759 -3590 48 4758 4760 -3591 48 4761 4762 -3592 48 4761 4763 -3593 48 4764 4765 -3594 48 4764 4766 -3595 48 4767 4768 -3596 48 4767 4769 -3597 48 4770 4771 -3598 48 4770 4772 -3599 48 4773 4774 -3600 48 4773 4775 -3601 48 4776 4777 -3602 48 4776 4778 -3603 48 4779 4780 -3604 48 4779 4781 -3605 48 4782 4783 -3606 48 4782 4784 -3607 48 4785 4786 -3608 48 4785 4787 -3609 48 4788 4789 -3610 48 4788 4790 -3611 48 4791 4792 -3612 48 4791 4793 -3613 48 4794 4795 -3614 48 4794 4796 -3615 48 4797 4798 -3616 48 4797 4799 -3617 48 4800 4801 -3618 48 4800 4802 -3619 48 4803 4804 -3620 48 4803 4805 -3621 48 4806 4807 -3622 48 4806 4808 -3623 48 4809 4810 -3624 48 4809 4811 -3625 48 4812 4813 -3626 48 4812 4814 -3627 48 4815 4816 -3628 48 4815 4817 -3629 48 4818 4819 -3630 48 4818 4820 -3631 48 4821 4822 -3632 48 4821 4823 -3633 48 4824 4825 -3634 48 4824 4826 -3635 48 4827 4828 -3636 48 4827 4829 -3637 48 4830 4831 -3638 48 4830 4832 -3639 48 4833 4834 -3640 48 4833 4835 -3641 48 4836 4837 -3642 48 4836 4838 -3643 48 4839 4840 -3644 48 4839 4841 -3645 48 4842 4843 -3646 48 4842 4844 -3647 48 4845 4846 -3648 48 4845 4847 -3649 48 4848 4849 -3650 48 4848 4850 -3651 48 4851 4852 -3652 48 4851 4853 -3653 48 4854 4855 -3654 48 4854 4856 -3655 48 4857 4858 -3656 48 4857 4859 -3657 48 4860 4861 -3658 48 4860 4862 -3659 48 4863 4864 -3660 48 4863 4865 -3661 48 4866 4867 -3662 48 4866 4868 -3663 48 4869 4870 -3664 48 4869 4871 -3665 48 4872 4873 -3666 48 4872 4874 -3667 48 4875 4876 -3668 48 4875 4877 -3669 48 4878 4879 -3670 48 4878 4880 -3671 48 4881 4882 -3672 48 4881 4883 -3673 48 4884 4885 -3674 48 4884 4886 -3675 48 4887 4888 -3676 48 4887 4889 -3677 48 4890 4891 -3678 48 4890 4892 -3679 48 4893 4894 -3680 48 4893 4895 -3681 48 4896 4897 -3682 48 4896 4898 -3683 48 4899 4900 -3684 48 4899 4901 -3685 48 4902 4903 -3686 48 4902 4904 -3687 48 4905 4906 -3688 48 4905 4907 -3689 48 4908 4909 -3690 48 4908 4910 -3691 48 4911 4912 -3692 48 4911 4913 -3693 48 4914 4915 -3694 48 4914 4916 -3695 48 4917 4918 -3696 48 4917 4919 -3697 48 4920 4921 -3698 48 4920 4922 -3699 48 4923 4924 -3700 48 4923 4925 -3701 48 4926 4927 -3702 48 4926 4928 -3703 48 4929 4930 -3704 48 4929 4931 -3705 48 4932 4933 -3706 48 4932 4934 -3707 48 4935 4936 -3708 48 4935 4937 -3709 48 4938 4939 -3710 48 4938 4940 -3711 48 4941 4942 -3712 48 4941 4943 -3713 48 4944 4945 -3714 48 4944 4946 -3715 48 4947 4948 -3716 48 4947 4949 -3717 48 4950 4951 -3718 48 4950 4952 -3719 48 4953 4954 -3720 48 4953 4955 -3721 48 4956 4957 -3722 48 4956 4958 -3723 48 4959 4960 -3724 48 4959 4961 -3725 48 4962 4963 -3726 48 4962 4964 -3727 48 4965 4966 -3728 48 4965 4967 -3729 48 4968 4969 -3730 48 4968 4970 -3731 48 4971 4972 -3732 48 4971 4973 -3733 48 4974 4975 -3734 48 4974 4976 -3735 48 4977 4978 -3736 48 4977 4979 -3737 48 4980 4981 -3738 48 4980 4982 -3739 48 4983 4984 -3740 48 4983 4985 -3741 48 4986 4987 -3742 48 4986 4988 -3743 48 4989 4990 -3744 48 4989 4991 -3745 48 4992 4993 -3746 48 4992 4994 -3747 48 4995 4996 -3748 48 4995 4997 -3749 48 4998 4999 -3750 48 4998 5000 -3751 48 5001 5002 -3752 48 5001 5003 -3753 48 5004 5005 -3754 48 5004 5006 -3755 48 5007 5008 -3756 48 5007 5009 -3757 48 5010 5011 -3758 48 5010 5012 -3759 48 5013 5014 -3760 48 5013 5015 -3761 48 5016 5017 -3762 48 5016 5018 -3763 48 5019 5020 -3764 48 5019 5021 -3765 48 5022 5023 -3766 48 5022 5024 -3767 48 5025 5026 -3768 48 5025 5027 -3769 48 5028 5029 -3770 48 5028 5030 -3771 48 5031 5032 -3772 48 5031 5033 -3773 48 5034 5035 -3774 48 5034 5036 -3775 48 5037 5038 -3776 48 5037 5039 -3777 48 5040 5041 -3778 48 5040 5042 -3779 48 5043 5044 -3780 48 5043 5045 -3781 48 5046 5047 -3782 48 5046 5048 -3783 48 5049 5050 -3784 48 5049 5051 -3785 48 5052 5053 -3786 48 5052 5054 -3787 48 5055 5056 -3788 48 5055 5057 -3789 48 5058 5059 -3790 48 5058 5060 -3791 48 5061 5062 -3792 48 5061 5063 -3793 48 5064 5065 -3794 48 5064 5066 -3795 48 5067 5068 -3796 48 5067 5069 -3797 48 5070 5071 -3798 48 5070 5072 -3799 48 5073 5074 -3800 48 5073 5075 -3801 48 5076 5077 -3802 48 5076 5078 -3803 48 5079 5080 -3804 48 5079 5081 -3805 48 5082 5083 -3806 48 5082 5084 -3807 48 5085 5086 -3808 48 5085 5087 -3809 48 5088 5089 -3810 48 5088 5090 -3811 48 5091 5092 -3812 48 5091 5093 -3813 48 5094 5095 -3814 48 5094 5096 -3815 48 5097 5098 -3816 48 5097 5099 -3817 48 5100 5101 -3818 48 5100 5102 -3819 48 5103 5104 -3820 48 5103 5105 -3821 48 5106 5107 -3822 48 5106 5108 -3823 48 5109 5110 -3824 48 5109 5111 -3825 48 5112 5113 -3826 48 5112 5114 -3827 48 5115 5116 -3828 48 5115 5117 -3829 48 5118 5119 -3830 48 5118 5120 -3831 48 5121 5122 -3832 48 5121 5123 -3833 48 5124 5125 -3834 48 5124 5126 -3835 48 5127 5128 -3836 48 5127 5129 -3837 48 5130 5131 -3838 48 5130 5132 -3839 48 5133 5134 -3840 48 5133 5135 -3841 48 5136 5137 -3842 48 5136 5138 -3843 48 5139 5140 -3844 48 5139 5141 -3845 48 5142 5143 -3846 48 5142 5144 -3847 48 5145 5146 -3848 48 5145 5147 -3849 48 5148 5149 -3850 48 5148 5150 -3851 48 5151 5152 -3852 48 5151 5153 -3853 48 5154 5155 -3854 48 5154 5156 -3855 48 5157 5158 -3856 48 5157 5159 -3857 48 5160 5161 -3858 48 5160 5162 -3859 48 5163 5164 -3860 48 5163 5165 -3861 48 5166 5167 -3862 48 5166 5168 -3863 48 5169 5170 -3864 48 5169 5171 -3865 48 5172 5173 -3866 48 5172 5174 -3867 48 5175 5176 -3868 48 5175 5177 -3869 48 5178 5179 -3870 48 5178 5180 -3871 48 5181 5182 -3872 48 5181 5183 -3873 48 5184 5185 -3874 48 5184 5186 -3875 48 5187 5188 -3876 48 5187 5189 -3877 48 5190 5191 -3878 48 5190 5192 -3879 48 5193 5194 -3880 48 5193 5195 -3881 48 5196 5197 -3882 48 5196 5198 -3883 48 5199 5200 -3884 48 5199 5201 -3885 48 5202 5203 -3886 48 5202 5204 -3887 48 5205 5206 -3888 48 5205 5207 -3889 48 5208 5209 -3890 48 5208 5210 -3891 48 5211 5212 -3892 48 5211 5213 -3893 48 5214 5215 -3894 48 5214 5216 -3895 48 5217 5218 -3896 48 5217 5219 -3897 48 5220 5221 -3898 48 5220 5222 -3899 48 5223 5224 -3900 48 5223 5225 -3901 48 5226 5227 -3902 48 5226 5228 -3903 48 5229 5230 -3904 48 5229 5231 -3905 48 5232 5233 -3906 48 5232 5234 -3907 48 5235 5236 -3908 48 5235 5237 -3909 48 5238 5239 -3910 48 5238 5240 -3911 48 5241 5242 -3912 48 5241 5243 -3913 48 5244 5245 -3914 48 5244 5246 -3915 48 5247 5248 -3916 48 5247 5249 -3917 48 5250 5251 -3918 48 5250 5252 -3919 48 5253 5254 -3920 48 5253 5255 -3921 48 5256 5257 -3922 48 5256 5258 -3923 48 5259 5260 -3924 48 5259 5261 -3925 48 5262 5263 -3926 48 5262 5264 -3927 48 5265 5266 -3928 48 5265 5267 -3929 48 5268 5269 -3930 48 5268 5270 -3931 48 5271 5272 -3932 48 5271 5273 -3933 48 5274 5275 -3934 48 5274 5276 -3935 48 5277 5278 -3936 48 5277 5279 -3937 48 5280 5281 -3938 48 5280 5282 -3939 48 5283 5284 -3940 48 5283 5285 -3941 48 5286 5287 -3942 48 5286 5288 -3943 48 5289 5290 -3944 48 5289 5291 -3945 48 5292 5293 -3946 48 5292 5294 -3947 48 5295 5296 -3948 48 5295 5297 -3949 48 5298 5299 -3950 48 5298 5300 -3951 48 5301 5302 -3952 48 5301 5303 -3953 48 5304 5305 -3954 48 5304 5306 -3955 48 5307 5308 -3956 48 5307 5309 -3957 48 5310 5311 -3958 48 5310 5312 -3959 48 5313 5314 -3960 48 5313 5315 -3961 48 5316 5317 -3962 48 5316 5318 -3963 48 5319 5320 -3964 48 5319 5321 -3965 48 5322 5323 -3966 48 5322 5324 -3967 48 5325 5326 -3968 48 5325 5327 -3969 48 5328 5329 -3970 48 5328 5330 -3971 48 5331 5332 -3972 48 5331 5333 -3973 48 5334 5335 -3974 48 5334 5336 -3975 48 5337 5338 -3976 48 5337 5339 -3977 48 5340 5341 -3978 48 5340 5342 -3979 48 5343 5344 -3980 48 5343 5345 -3981 48 5346 5347 -3982 48 5346 5348 -3983 48 5349 5350 -3984 48 5349 5351 -3985 48 5352 5353 -3986 48 5352 5354 -3987 48 5355 5356 -3988 48 5355 5357 -3989 48 5358 5359 -3990 48 5358 5360 -3991 48 5361 5362 -3992 48 5361 5363 -3993 48 5364 5365 -3994 48 5364 5366 -3995 48 5367 5368 -3996 48 5367 5369 -3997 48 5370 5371 -3998 48 5370 5372 -3999 48 5373 5374 -4000 48 5373 5375 -4001 48 5376 5377 -4002 48 5376 5378 -4003 48 5379 5380 -4004 48 5379 5381 -4005 48 5382 5383 -4006 48 5382 5384 -4007 48 5385 5386 -4008 48 5385 5387 -4009 48 5388 5389 -4010 48 5388 5390 -4011 48 5391 5392 -4012 48 5391 5393 -4013 48 5394 5395 -4014 48 5394 5396 -4015 48 5397 5398 -4016 48 5397 5399 -4017 48 5400 5401 -4018 48 5400 5402 -4019 48 5403 5404 -4020 48 5403 5405 -4021 48 5406 5407 -4022 48 5406 5408 -4023 48 5409 5410 -4024 48 5409 5411 -4025 48 5412 5413 -4026 48 5412 5414 -4027 48 5415 5416 -4028 48 5415 5417 -4029 48 5418 5419 -4030 48 5418 5420 -4031 48 5421 5422 -4032 48 5421 5423 -4033 48 5424 5425 -4034 48 5424 5426 -4035 48 5427 5428 -4036 48 5427 5429 -4037 48 5430 5431 -4038 48 5430 5432 -4039 48 5433 5434 -4040 48 5433 5435 -4041 48 5436 5437 -4042 48 5436 5438 -4043 48 5439 5440 -4044 48 5439 5441 -4045 48 5442 5443 -4046 48 5442 5444 -4047 48 5445 5446 -4048 48 5445 5447 -4049 48 5448 5449 -4050 48 5448 5450 -4051 48 5451 5452 -4052 48 5451 5453 -4053 48 5454 5455 -4054 48 5454 5456 -4055 48 5457 5458 -4056 48 5457 5459 -4057 48 5460 5461 -4058 48 5460 5462 -4059 48 5463 5464 -4060 48 5463 5465 -4061 48 5466 5467 -4062 48 5466 5468 -4063 48 5469 5470 -4064 48 5469 5471 -4065 48 5472 5473 -4066 48 5472 5474 -4067 48 5475 5476 -4068 48 5475 5477 -4069 48 5478 5479 -4070 48 5478 5480 -4071 48 5481 5482 -4072 48 5481 5483 -4073 48 5484 5485 -4074 48 5484 5486 -4075 48 5487 5488 -4076 48 5487 5489 -4077 48 5490 5491 -4078 48 5490 5492 -4079 48 5493 5494 -4080 48 5493 5495 -4081 48 5496 5497 -4082 48 5496 5498 -4083 48 5499 5500 -4084 48 5499 5501 -4085 48 5502 5503 -4086 48 5502 5504 -4087 48 5505 5506 -4088 48 5505 5507 -4089 48 5508 5509 -4090 48 5508 5510 -4091 48 5511 5512 -4092 48 5511 5513 -4093 48 5514 5515 -4094 48 5514 5516 -4095 48 5517 5518 -4096 48 5517 5519 -4097 48 5520 5521 -4098 48 5520 5522 -4099 48 5523 5524 -4100 48 5523 5525 -4101 48 5526 5527 -4102 48 5526 5528 -4103 48 5529 5530 -4104 48 5529 5531 -4105 48 5532 5533 -4106 48 5532 5534 -4107 48 5535 5536 -4108 48 5535 5537 -4109 48 5538 5539 -4110 48 5538 5540 -4111 48 5541 5542 -4112 48 5541 5543 -4113 48 5544 5545 -4114 48 5544 5546 -4115 48 5547 5548 -4116 48 5547 5549 -4117 48 5550 5551 -4118 48 5550 5552 -4119 48 5553 5554 -4120 48 5553 5555 -4121 48 5556 5557 -4122 48 5556 5558 -4123 48 5559 5560 -4124 48 5559 5561 -4125 48 5562 5563 -4126 48 5562 5564 -4127 48 5565 5566 -4128 48 5565 5567 -4129 48 5568 5569 -4130 48 5568 5570 -4131 48 5571 5572 -4132 48 5571 5573 -4133 48 5574 5575 -4134 48 5574 5576 -4135 48 5577 5578 -4136 48 5577 5579 -4137 48 5580 5581 -4138 48 5580 5582 -4139 48 5583 5584 -4140 48 5583 5585 -4141 48 5586 5587 -4142 48 5586 5588 -4143 48 5589 5590 -4144 48 5589 5591 -4145 48 5592 5593 -4146 48 5592 5594 -4147 48 5595 5596 -4148 48 5595 5597 -4149 48 5598 5599 -4150 48 5598 5600 -4151 48 5601 5602 -4152 48 5601 5603 -4153 48 5604 5605 -4154 48 5604 5606 -4155 48 5607 5608 -4156 48 5607 5609 -4157 48 5610 5611 -4158 48 5610 5612 -4159 48 5613 5614 -4160 48 5613 5615 -4161 48 5616 5617 -4162 48 5616 5618 -4163 48 5619 5620 -4164 48 5619 5621 -4165 48 5622 5623 -4166 48 5622 5624 -4167 48 5625 5626 -4168 48 5625 5627 -4169 48 5628 5629 -4170 48 5628 5630 -4171 48 5631 5632 -4172 48 5631 5633 -4173 48 5634 5635 -4174 48 5634 5636 -4175 48 5637 5638 -4176 48 5637 5639 -4177 48 5640 5641 -4178 48 5640 5642 -4179 48 5643 5644 -4180 48 5643 5645 -4181 48 5646 5647 -4182 48 5646 5648 -4183 48 5649 5650 -4184 48 5649 5651 -4185 48 5652 5653 -4186 48 5652 5654 -4187 48 5655 5656 -4188 48 5655 5657 -4189 48 5658 5659 -4190 48 5658 5660 -4191 48 5661 5662 -4192 48 5661 5663 -4193 48 5664 5665 -4194 48 5664 5666 -4195 48 5667 5668 -4196 48 5667 5669 -4197 48 5670 5671 -4198 48 5670 5672 -4199 48 5673 5674 -4200 48 5673 5675 -4201 48 5676 5677 -4202 48 5676 5678 -4203 48 5679 5680 -4204 48 5679 5681 -4205 48 5682 5683 -4206 48 5682 5684 -4207 48 5685 5686 -4208 48 5685 5687 -4209 48 5688 5689 -4210 48 5688 5690 -4211 48 5691 5692 -4212 48 5691 5693 -4213 48 5694 5695 -4214 48 5694 5696 -4215 48 5697 5698 -4216 48 5697 5699 -4217 48 5700 5701 -4218 48 5700 5702 -4219 48 5703 5704 -4220 48 5703 5705 -4221 48 5706 5707 -4222 48 5706 5708 -4223 48 5709 5710 -4224 48 5709 5711 -4225 48 5712 5713 -4226 48 5712 5714 -4227 48 5715 5716 -4228 48 5715 5717 -4229 48 5718 5719 -4230 48 5718 5720 -4231 48 5721 5722 -4232 48 5721 5723 -4233 48 5724 5725 -4234 48 5724 5726 -4235 48 5727 5728 -4236 48 5727 5729 -4237 48 5730 5731 -4238 48 5730 5732 -4239 48 5733 5734 -4240 48 5733 5735 -4241 48 5736 5737 -4242 48 5736 5738 -4243 48 5739 5740 -4244 48 5739 5741 -4245 48 5742 5743 -4246 48 5742 5744 -4247 48 5745 5746 -4248 48 5745 5747 -4249 48 5748 5749 -4250 48 5748 5750 -4251 48 5751 5752 -4252 48 5751 5753 -4253 48 5754 5755 -4254 48 5754 5756 -4255 48 5757 5758 -4256 48 5757 5759 -4257 48 5760 5761 -4258 48 5760 5762 -4259 48 5763 5764 -4260 48 5763 5765 -4261 48 5766 5767 -4262 48 5766 5768 -4263 48 5769 5770 -4264 48 5769 5771 -4265 48 5772 5773 -4266 48 5772 5774 -4267 48 5775 5776 -4268 48 5775 5777 -4269 48 5778 5779 -4270 48 5778 5780 -4271 48 5781 5782 -4272 48 5781 5783 -4273 48 5784 5785 -4274 48 5784 5786 -4275 48 5787 5788 -4276 48 5787 5789 -4277 48 5790 5791 -4278 48 5790 5792 -4279 48 5793 5794 -4280 48 5793 5795 -4281 48 5796 5797 -4282 48 5796 5798 -4283 48 5799 5800 -4284 48 5799 5801 -4285 48 5802 5803 -4286 48 5802 5804 -4287 48 5805 5806 -4288 48 5805 5807 -4289 48 5808 5809 -4290 48 5808 5810 -4291 48 5811 5812 -4292 48 5811 5813 -4293 48 5814 5815 -4294 48 5814 5816 -4295 48 5817 5818 -4296 48 5817 5819 -4297 48 5820 5821 -4298 48 5820 5822 -4299 48 5823 5824 -4300 48 5823 5825 -4301 48 5826 5827 -4302 48 5826 5828 -4303 48 5829 5830 -4304 48 5829 5831 -4305 48 5832 5833 -4306 48 5832 5834 -4307 48 5835 5836 -4308 48 5835 5837 -4309 48 5838 5839 -4310 48 5838 5840 -4311 48 5841 5842 -4312 48 5841 5843 -4313 48 5844 5845 -4314 48 5844 5846 -4315 48 5847 5848 -4316 48 5847 5849 -4317 48 5850 5851 -4318 48 5850 5852 -4319 48 5853 5854 -4320 48 5853 5855 -4321 48 5856 5857 -4322 48 5856 5858 -4323 48 5859 5860 -4324 48 5859 5861 -4325 48 5862 5863 -4326 48 5862 5864 -4327 48 5865 5866 -4328 48 5865 5867 -4329 48 5868 5869 -4330 48 5868 5870 -4331 48 5871 5872 -4332 48 5871 5873 -4333 48 5874 5875 -4334 48 5874 5876 -4335 48 5877 5878 -4336 48 5877 5879 -4337 48 5880 5881 -4338 48 5880 5882 -4339 48 5883 5884 -4340 48 5883 5885 -4341 48 5886 5887 -4342 48 5886 5888 -4343 48 5889 5890 -4344 48 5889 5891 -4345 48 5892 5893 -4346 48 5892 5894 -4347 48 5895 5896 -4348 48 5895 5897 -4349 48 5898 5899 -4350 48 5898 5900 -4351 48 5901 5902 -4352 48 5901 5903 -4353 48 5904 5905 -4354 48 5904 5906 -4355 48 5907 5908 -4356 48 5907 5909 -4357 48 5910 5911 -4358 48 5910 5912 -4359 48 5913 5914 -4360 48 5913 5915 -4361 48 5916 5917 -4362 48 5916 5918 -4363 48 5919 5920 -4364 48 5919 5921 -4365 48 5922 5923 -4366 48 5922 5924 -4367 48 5925 5926 -4368 48 5925 5927 -4369 48 5928 5929 -4370 48 5928 5930 -4371 48 5931 5932 -4372 48 5931 5933 -4373 48 5934 5935 -4374 48 5934 5936 -4375 48 5937 5938 -4376 48 5937 5939 -4377 48 5940 5941 -4378 48 5940 5942 -4379 48 5943 5944 -4380 48 5943 5945 -4381 48 5946 5947 -4382 48 5946 5948 -4383 48 5949 5950 -4384 48 5949 5951 -4385 48 5952 5953 -4386 48 5952 5954 -4387 48 5955 5956 -4388 48 5955 5957 -4389 48 5958 5959 -4390 48 5958 5960 -4391 48 5961 5962 -4392 48 5961 5963 -4393 48 5964 5965 -4394 48 5964 5966 -4395 48 5967 5968 -4396 48 5967 5969 -4397 48 5970 5971 -4398 48 5970 5972 -4399 48 5973 5974 -4400 48 5973 5975 -4401 48 5976 5977 -4402 48 5976 5978 -4403 48 5979 5980 -4404 48 5979 5981 -4405 48 5982 5983 -4406 48 5982 5984 -4407 48 5985 5986 -4408 48 5985 5987 -4409 48 5988 5989 -4410 48 5988 5990 -4411 48 5991 5992 -4412 48 5991 5993 -4413 48 5994 5995 -4414 48 5994 5996 -4415 48 5997 5998 -4416 48 5997 5999 -4417 48 6000 6001 -4418 48 6000 6002 -4419 48 6003 6004 -4420 48 6003 6005 -4421 48 6006 6007 -4422 48 6006 6008 -4423 48 6009 6010 -4424 48 6009 6011 -4425 48 6012 6013 -4426 48 6012 6014 -4427 48 6015 6016 -4428 48 6015 6017 -4429 48 6018 6019 -4430 48 6018 6020 -4431 48 6021 6022 -4432 48 6021 6023 -4433 48 6024 6025 -4434 48 6024 6026 -4435 48 6027 6028 -4436 48 6027 6029 -4437 48 6030 6031 -4438 48 6030 6032 -4439 48 6033 6034 -4440 48 6033 6035 -4441 48 6036 6037 -4442 48 6036 6038 -4443 48 6039 6040 -4444 48 6039 6041 -4445 48 6042 6043 -4446 48 6042 6044 -4447 48 6045 6046 -4448 48 6045 6047 -4449 48 6048 6049 -4450 48 6048 6050 -4451 48 6051 6052 -4452 48 6051 6053 -4453 48 6054 6055 -4454 48 6054 6056 -4455 48 6057 6058 -4456 48 6057 6059 -4457 48 6060 6061 -4458 48 6060 6062 -4459 48 6063 6064 -4460 48 6063 6065 -4461 48 6066 6067 -4462 48 6066 6068 -4463 48 6069 6070 -4464 48 6069 6071 -4465 48 6072 6073 -4466 48 6072 6074 -4467 48 6075 6076 -4468 48 6075 6077 -4469 48 6078 6079 -4470 48 6078 6080 -4471 48 6081 6082 -4472 48 6081 6083 -4473 48 6084 6085 -4474 48 6084 6086 -4475 48 6087 6088 -4476 48 6087 6089 -4477 48 6090 6091 -4478 48 6090 6092 -4479 48 6093 6094 -4480 48 6093 6095 -4481 48 6096 6097 -4482 48 6096 6098 -4483 48 6099 6100 -4484 48 6099 6101 -4485 48 6102 6103 -4486 48 6102 6104 -4487 48 6105 6106 -4488 48 6105 6107 -4489 48 6108 6109 -4490 48 6108 6110 -4491 48 6111 6112 -4492 48 6111 6113 -4493 48 6114 6115 -4494 48 6114 6116 -4495 48 6117 6118 -4496 48 6117 6119 -4497 48 6120 6121 -4498 48 6120 6122 -4499 48 6123 6124 -4500 48 6123 6125 -4501 48 6126 6127 -4502 48 6126 6128 -4503 48 6129 6130 -4504 48 6129 6131 -4505 48 6132 6133 -4506 48 6132 6134 -4507 48 6135 6136 -4508 48 6135 6137 -4509 48 6138 6139 -4510 48 6138 6140 -4511 48 6141 6142 -4512 48 6141 6143 -4513 48 6144 6145 -4514 48 6144 6146 -4515 48 6147 6148 -4516 48 6147 6149 -4517 48 6150 6151 -4518 48 6150 6152 -4519 48 6153 6154 -4520 48 6153 6155 -4521 48 6156 6157 -4522 48 6156 6158 -4523 48 6159 6160 -4524 48 6159 6161 -4525 48 6162 6163 -4526 48 6162 6164 -4527 48 6165 6166 -4528 48 6165 6167 -4529 48 6168 6169 -4530 48 6168 6170 -4531 48 6171 6172 -4532 48 6171 6173 -4533 48 6174 6175 -4534 48 6174 6176 -4535 48 6177 6178 -4536 48 6177 6179 -4537 48 6180 6181 -4538 48 6180 6182 -4539 48 6183 6184 -4540 48 6183 6185 -4541 48 6186 6187 -4542 48 6186 6188 -4543 48 6189 6190 -4544 48 6189 6191 -4545 48 6192 6193 -4546 48 6192 6194 -4547 48 6195 6196 -4548 48 6195 6197 -4549 48 6198 6199 -4550 48 6198 6200 -4551 48 6201 6202 -4552 48 6201 6203 -4553 48 6204 6205 -4554 48 6204 6206 -4555 48 6207 6208 -4556 48 6207 6209 -4557 48 6210 6211 -4558 48 6210 6212 -4559 48 6213 6214 -4560 48 6213 6215 -4561 48 6216 6217 -4562 48 6216 6218 -4563 48 6219 6220 -4564 48 6219 6221 -4565 48 6222 6223 -4566 48 6222 6224 -4567 48 6225 6226 -4568 48 6225 6227 -4569 48 6228 6229 -4570 48 6228 6230 -4571 48 6231 6232 -4572 48 6231 6233 -4573 48 6234 6235 -4574 48 6234 6236 -4575 48 6237 6238 -4576 48 6237 6239 -4577 48 6240 6241 -4578 48 6240 6242 -4579 48 6243 6244 -4580 48 6243 6245 -4581 48 6246 6247 -4582 48 6246 6248 -4583 48 6249 6250 -4584 48 6249 6251 -4585 48 6252 6253 -4586 48 6252 6254 -4587 48 6255 6256 -4588 48 6255 6257 -4589 48 6258 6259 -4590 48 6258 6260 -4591 48 6261 6262 -4592 48 6261 6263 -4593 48 6264 6265 -4594 48 6264 6266 -4595 48 6267 6268 -4596 48 6267 6269 -4597 48 6270 6271 -4598 48 6270 6272 -4599 48 6273 6274 -4600 48 6273 6275 -4601 48 6276 6277 -4602 48 6276 6278 -4603 48 6279 6280 -4604 48 6279 6281 -4605 48 6282 6283 -4606 48 6282 6284 -4607 48 6285 6286 -4608 48 6285 6287 -4609 48 6288 6289 -4610 48 6288 6290 -4611 48 6291 6292 -4612 48 6291 6293 -4613 48 6294 6295 -4614 48 6294 6296 -4615 48 6297 6298 -4616 48 6297 6299 -4617 48 6300 6301 -4618 48 6300 6302 -4619 48 6303 6304 -4620 48 6303 6305 -4621 48 6306 6307 -4622 48 6306 6308 -4623 48 6309 6310 -4624 48 6309 6311 -4625 48 6312 6313 -4626 48 6312 6314 -4627 48 6315 6316 -4628 48 6315 6317 -4629 48 6318 6319 -4630 48 6318 6320 -4631 48 6321 6322 -4632 48 6321 6323 -4633 48 6324 6325 -4634 48 6324 6326 -4635 48 6327 6328 -4636 48 6327 6329 -4637 48 6330 6331 -4638 48 6330 6332 -4639 48 6333 6334 -4640 48 6333 6335 -4641 48 6336 6337 -4642 48 6336 6338 -4643 48 6339 6340 -4644 48 6339 6341 -4645 48 6342 6343 -4646 48 6342 6344 -4647 48 6345 6346 -4648 48 6345 6347 -4649 48 6348 6349 -4650 48 6348 6350 -4651 48 6351 6352 -4652 48 6351 6353 -4653 48 6354 6355 -4654 48 6354 6356 -4655 48 6357 6358 -4656 48 6357 6359 -4657 48 6360 6361 -4658 48 6360 6362 -4659 48 6363 6364 -4660 48 6363 6365 -4661 48 6366 6367 -4662 48 6366 6368 -4663 48 6369 6370 -4664 48 6369 6371 -4665 48 6372 6373 -4666 48 6372 6374 -4667 48 6375 6376 -4668 48 6375 6377 -4669 48 6378 6379 -4670 48 6378 6380 -4671 48 6381 6382 -4672 48 6381 6383 -4673 48 6384 6385 -4674 48 6384 6386 -4675 48 6387 6388 -4676 48 6387 6389 -4677 48 6390 6391 -4678 48 6390 6392 -4679 48 6393 6394 -4680 48 6393 6395 -4681 48 6396 6397 -4682 48 6396 6398 -4683 48 6399 6400 -4684 48 6399 6401 -4685 48 6402 6403 -4686 48 6402 6404 -4687 48 6405 6406 -4688 48 6405 6407 -4689 48 6408 6409 -4690 48 6408 6410 -4691 48 6411 6412 -4692 48 6411 6413 -4693 48 6414 6415 -4694 48 6414 6416 -4695 48 6417 6418 -4696 48 6417 6419 -4697 48 6420 6421 -4698 48 6420 6422 -4699 48 6423 6424 -4700 48 6423 6425 -4701 48 6426 6427 -4702 48 6426 6428 -4703 48 6429 6430 -4704 48 6429 6431 -4705 48 6432 6433 -4706 48 6432 6434 -4707 48 6435 6436 -4708 48 6435 6437 -4709 48 6438 6439 -4710 48 6438 6440 -4711 48 6441 6442 -4712 48 6441 6443 -4713 48 6444 6445 -4714 48 6444 6446 -4715 48 6447 6448 -4716 48 6447 6449 -4717 48 6450 6451 -4718 48 6450 6452 -4719 48 6453 6454 -4720 48 6453 6455 -4721 48 6456 6457 -4722 48 6456 6458 -4723 48 6459 6460 -4724 48 6459 6461 -4725 48 6462 6463 -4726 48 6462 6464 -4727 48 6465 6466 -4728 48 6465 6467 -4729 48 6468 6469 -4730 48 6468 6470 -4731 48 6471 6472 -4732 48 6471 6473 -4733 48 6474 6475 -4734 48 6474 6476 -4735 48 6477 6478 -4736 48 6477 6479 -4737 48 6480 6481 -4738 48 6480 6482 -4739 48 6483 6484 -4740 48 6483 6485 -4741 48 6486 6487 -4742 48 6486 6488 -4743 48 6489 6490 -4744 48 6489 6491 -4745 48 6492 6493 -4746 48 6492 6494 -4747 48 6495 6496 -4748 48 6495 6497 -4749 48 6498 6499 -4750 48 6498 6500 -4751 48 6501 6502 -4752 48 6501 6503 -4753 48 6504 6505 -4754 48 6504 6506 -4755 48 6507 6508 -4756 48 6507 6509 -4757 48 6510 6511 -4758 48 6510 6512 -4759 48 6513 6514 -4760 48 6513 6515 -4761 48 6516 6517 -4762 48 6516 6518 -4763 48 6519 6520 -4764 48 6519 6521 -4765 48 6522 6523 -4766 48 6522 6524 -4767 48 6525 6526 -4768 48 6525 6527 -4769 48 6528 6529 -4770 48 6528 6530 -4771 48 6531 6532 -4772 48 6531 6533 -4773 48 6534 6535 -4774 48 6534 6536 -4775 48 6537 6538 -4776 48 6537 6539 -4777 48 6540 6541 -4778 48 6540 6542 -4779 48 6543 6544 -4780 48 6543 6545 -4781 48 6546 6547 -4782 48 6546 6548 -4783 48 6549 6550 -4784 48 6549 6551 -4785 48 6552 6553 -4786 48 6552 6554 -4787 48 6555 6556 -4788 48 6555 6557 -4789 48 6558 6559 -4790 48 6558 6560 -4791 48 6561 6562 -4792 48 6561 6563 -4793 48 6564 6565 -4794 48 6564 6566 -4795 48 6567 6568 -4796 48 6567 6569 -4797 48 6570 6571 -4798 48 6570 6572 -4799 48 6573 6574 -4800 48 6573 6575 -4801 48 6576 6577 -4802 48 6576 6578 -4803 48 6579 6580 -4804 48 6579 6581 -4805 48 6582 6583 -4806 48 6582 6584 -4807 48 6585 6586 -4808 48 6585 6587 -4809 48 6588 6589 -4810 48 6588 6590 -4811 48 6591 6592 -4812 48 6591 6593 -4813 48 6594 6595 -4814 48 6594 6596 -4815 48 6597 6598 -4816 48 6597 6599 -4817 48 6600 6601 -4818 48 6600 6602 -4819 48 6603 6604 -4820 48 6603 6605 -4821 48 6606 6607 -4822 48 6606 6608 -4823 48 6609 6610 -4824 48 6609 6611 -4825 48 6612 6613 -4826 48 6612 6614 -4827 48 6615 6616 -4828 48 6615 6617 -4829 48 6618 6619 -4830 48 6618 6620 -4831 48 6621 6622 -4832 48 6621 6623 -4833 48 6624 6625 -4834 48 6624 6626 -4835 48 6627 6628 -4836 48 6627 6629 -4837 48 6630 6631 -4838 48 6630 6632 -4839 48 6633 6634 -4840 48 6633 6635 -4841 48 6636 6637 -4842 48 6636 6638 -4843 48 6639 6640 -4844 48 6639 6641 -4845 48 6642 6643 -4846 48 6642 6644 -4847 48 6645 6646 -4848 48 6645 6647 -4849 48 6648 6649 -4850 48 6648 6650 -4851 48 6651 6652 -4852 48 6651 6653 -4853 48 6654 6655 -4854 48 6654 6656 -4855 48 6657 6658 -4856 48 6657 6659 -4857 48 6660 6661 -4858 48 6660 6662 -4859 48 6663 6664 -4860 48 6663 6665 -4861 48 6666 6667 -4862 48 6666 6668 -4863 48 6669 6670 -4864 48 6669 6671 -4865 48 6672 6673 -4866 48 6672 6674 -4867 48 6675 6676 -4868 48 6675 6677 -4869 48 6678 6679 -4870 48 6678 6680 -4871 48 6681 6682 -4872 48 6681 6683 -4873 48 6684 6685 -4874 48 6684 6686 -4875 48 6687 6688 -4876 48 6687 6689 -4877 48 6690 6691 -4878 48 6690 6692 -4879 48 6693 6694 -4880 48 6693 6695 -4881 48 6696 6697 -4882 48 6696 6698 -4883 48 6699 6700 -4884 48 6699 6701 -4885 48 6702 6703 -4886 48 6702 6704 -4887 48 6705 6706 -4888 48 6705 6707 -4889 48 6708 6709 -4890 48 6708 6710 -4891 48 6711 6712 -4892 48 6711 6713 -4893 48 6714 6715 -4894 48 6714 6716 -4895 48 6717 6718 -4896 48 6717 6719 -4897 48 6720 6721 -4898 48 6720 6722 -4899 48 6723 6724 -4900 48 6723 6725 -4901 48 6726 6727 -4902 48 6726 6728 -4903 48 6729 6730 -4904 48 6729 6731 -4905 48 6732 6733 -4906 48 6732 6734 -4907 48 6735 6736 -4908 48 6735 6737 -4909 48 6738 6739 -4910 48 6738 6740 -4911 48 6741 6742 -4912 48 6741 6743 -4913 48 6744 6745 -4914 48 6744 6746 -4915 48 6747 6748 -4916 48 6747 6749 -4917 48 6750 6751 -4918 48 6750 6752 -4919 48 6753 6754 -4920 48 6753 6755 -4921 48 6756 6757 -4922 48 6756 6758 -4923 48 6759 6760 -4924 48 6759 6761 -4925 48 6762 6763 -4926 48 6762 6764 -4927 48 6765 6766 -4928 48 6765 6767 -4929 48 6768 6769 -4930 48 6768 6770 -4931 48 6771 6772 -4932 48 6771 6773 -4933 48 6774 6775 -4934 48 6774 6776 -4935 48 6777 6778 -4936 48 6777 6779 -4937 48 6780 6781 -4938 48 6780 6782 -4939 48 6783 6784 -4940 48 6783 6785 -4941 48 6786 6787 -4942 48 6786 6788 -4943 48 6789 6790 -4944 48 6789 6791 -4945 48 6792 6793 -4946 48 6792 6794 -4947 48 6795 6796 -4948 48 6795 6797 -4949 48 6798 6799 -4950 48 6798 6800 -4951 48 6801 6802 -4952 48 6801 6803 -4953 48 6804 6805 -4954 48 6804 6806 -4955 48 6807 6808 -4956 48 6807 6809 -4957 48 6810 6811 -4958 48 6810 6812 -4959 48 6813 6814 -4960 48 6813 6815 -4961 48 6816 6817 -4962 48 6816 6818 -4963 48 6819 6820 -4964 48 6819 6821 -4965 48 6822 6823 -4966 48 6822 6824 -4967 48 6825 6826 -4968 48 6825 6827 -4969 48 6828 6829 -4970 48 6828 6830 -4971 48 6831 6832 -4972 48 6831 6833 -4973 48 6834 6835 -4974 48 6834 6836 -4975 48 6837 6838 -4976 48 6837 6839 -4977 48 6840 6841 -4978 48 6840 6842 -4979 48 6843 6844 -4980 48 6843 6845 -4981 48 6846 6847 -4982 48 6846 6848 -4983 48 6849 6850 -4984 48 6849 6851 -4985 48 6852 6853 -4986 48 6852 6854 -4987 48 6855 6856 -4988 48 6855 6857 -4989 48 6858 6859 -4990 48 6858 6860 -4991 48 6861 6862 -4992 48 6861 6863 -4993 48 6864 6865 -4994 48 6864 6866 -4995 48 6867 6868 -4996 48 6867 6869 -4997 48 6870 6871 -4998 48 6870 6872 -4999 48 6873 6874 -5000 48 6873 6875 -5001 48 6876 6877 -5002 48 6876 6878 -5003 48 6879 6880 -5004 48 6879 6881 -5005 48 6882 6883 -5006 48 6882 6884 -5007 48 6885 6886 -5008 48 6885 6887 -5009 48 6888 6889 -5010 48 6888 6890 -5011 48 6891 6892 -5012 48 6891 6893 -5013 48 6894 6895 -5014 48 6894 6896 -5015 48 6897 6898 -5016 48 6897 6899 -5017 48 6900 6901 -5018 48 6900 6902 -5019 48 6903 6904 -5020 48 6903 6905 -5021 48 6906 6907 -5022 48 6906 6908 -5023 48 6909 6910 -5024 48 6909 6911 -5025 48 6912 6913 -5026 48 6912 6914 -5027 48 6915 6916 -5028 48 6915 6917 -5029 48 6918 6919 -5030 48 6918 6920 -5031 48 6921 6922 -5032 48 6921 6923 -5033 48 6924 6925 -5034 48 6924 6926 -5035 48 6927 6928 -5036 48 6927 6929 -5037 48 6930 6931 -5038 48 6930 6932 -5039 48 6933 6934 -5040 48 6933 6935 -5041 48 6936 6937 -5042 48 6936 6938 -5043 48 6939 6940 -5044 48 6939 6941 -5045 48 6942 6943 -5046 48 6942 6944 -5047 48 6945 6946 -5048 48 6945 6947 -5049 48 6948 6949 -5050 48 6948 6950 -5051 48 6951 6952 -5052 48 6951 6953 -5053 48 6954 6955 -5054 48 6954 6956 -5055 48 6957 6958 -5056 48 6957 6959 -5057 48 6960 6961 -5058 48 6960 6962 -5059 48 6963 6964 -5060 48 6963 6965 -5061 48 6966 6967 -5062 48 6966 6968 -5063 48 6969 6970 -5064 48 6969 6971 -5065 48 6972 6973 -5066 48 6972 6974 -5067 48 6975 6976 -5068 48 6975 6977 -5069 48 6978 6979 -5070 48 6978 6980 -5071 48 6981 6982 -5072 48 6981 6983 -5073 48 6984 6985 -5074 48 6984 6986 -5075 48 6987 6988 -5076 48 6987 6989 -5077 48 6990 6991 -5078 48 6990 6992 -5079 48 6993 6994 -5080 48 6993 6995 -5081 48 6996 6997 -5082 48 6996 6998 -5083 48 6999 7000 -5084 48 6999 7001 -5085 48 7002 7003 -5086 48 7002 7004 -5087 48 7005 7006 -5088 48 7005 7007 -5089 48 7008 7009 -5090 48 7008 7010 -5091 48 7011 7012 -5092 48 7011 7013 -5093 48 7014 7015 -5094 48 7014 7016 -5095 48 7017 7018 -5096 48 7017 7019 -5097 48 7020 7021 -5098 48 7020 7022 -5099 48 7023 7024 -5100 48 7023 7025 -5101 48 7026 7027 -5102 48 7026 7028 -5103 48 7029 7030 -5104 48 7029 7031 -5105 48 7032 7033 -5106 48 7032 7034 -5107 48 7035 7036 -5108 48 7035 7037 -5109 48 7038 7039 -5110 48 7038 7040 -5111 48 7041 7042 -5112 48 7041 7043 -5113 48 7044 7045 -5114 48 7044 7046 -5115 48 7047 7048 -5116 48 7047 7049 -5117 48 7050 7051 -5118 48 7050 7052 -5119 48 7053 7054 -5120 48 7053 7055 -5121 48 7056 7057 -5122 48 7056 7058 -5123 48 7059 7060 -5124 48 7059 7061 -5125 48 7062 7063 -5126 48 7062 7064 -5127 48 7065 7066 -5128 48 7065 7067 -5129 48 7068 7069 -5130 48 7068 7070 -5131 48 7071 7072 -5132 48 7071 7073 -5133 48 7074 7075 -5134 48 7074 7076 -5135 48 7077 7078 -5136 48 7077 7079 -5137 48 7080 7081 -5138 48 7080 7082 -5139 48 7083 7084 -5140 48 7083 7085 -5141 48 7086 7087 -5142 48 7086 7088 -5143 48 7089 7090 -5144 48 7089 7091 -5145 48 7092 7093 -5146 48 7092 7094 -5147 48 7095 7096 -5148 48 7095 7097 -5149 48 7098 7099 -5150 48 7098 7100 -5151 48 7101 7102 -5152 48 7101 7103 -5153 48 7104 7105 -5154 48 7104 7106 -5155 48 7107 7108 -5156 48 7107 7109 -5157 48 7110 7111 -5158 48 7110 7112 -5159 48 7113 7114 -5160 48 7113 7115 -5161 48 7116 7117 -5162 48 7116 7118 -5163 48 7119 7120 -5164 48 7119 7121 -5165 48 7122 7123 -5166 48 7122 7124 -5167 48 7125 7126 -5168 48 7125 7127 -5169 48 7128 7129 -5170 48 7128 7130 -5171 48 7131 7132 -5172 48 7131 7133 -5173 48 7134 7135 -5174 48 7134 7136 -5175 48 7137 7138 -5176 48 7137 7139 -5177 48 7140 7141 -5178 48 7140 7142 -5179 48 7143 7144 -5180 48 7143 7145 -5181 48 7146 7147 -5182 48 7146 7148 -5183 48 7149 7150 -5184 48 7149 7151 -5185 48 7152 7153 -5186 48 7152 7154 -5187 48 7155 7156 -5188 48 7155 7157 -5189 48 7158 7159 -5190 48 7158 7160 -5191 48 7161 7162 -5192 48 7161 7163 -5193 48 7164 7165 -5194 48 7164 7166 -5195 48 7167 7168 -5196 48 7167 7169 -5197 48 7170 7171 -5198 48 7170 7172 -5199 48 7173 7174 -5200 48 7173 7175 -5201 48 7176 7177 -5202 48 7176 7178 -5203 48 7179 7180 -5204 48 7179 7181 -5205 48 7182 7183 -5206 48 7182 7184 -5207 48 7185 7186 -5208 48 7185 7187 -5209 48 7188 7189 -5210 48 7188 7190 -5211 48 7191 7192 -5212 48 7191 7193 -5213 48 7194 7195 -5214 48 7194 7196 -5215 48 7197 7198 -5216 48 7197 7199 -5217 48 7200 7201 -5218 48 7200 7202 -5219 48 7203 7204 -5220 48 7203 7205 -5221 48 7206 7207 -5222 48 7206 7208 -5223 48 7209 7210 -5224 48 7209 7211 -5225 48 7212 7213 -5226 48 7212 7214 -5227 48 7215 7216 -5228 48 7215 7217 -5229 48 7218 7219 -5230 48 7218 7220 -5231 48 7221 7222 -5232 48 7221 7223 -5233 48 7224 7225 -5234 48 7224 7226 -5235 48 7227 7228 -5236 48 7227 7229 -5237 48 7230 7231 -5238 48 7230 7232 -5239 48 7233 7234 -5240 48 7233 7235 -5241 48 7236 7237 -5242 48 7236 7238 -5243 48 7239 7240 -5244 48 7239 7241 -5245 48 7242 7243 -5246 48 7242 7244 -5247 48 7245 7246 -5248 48 7245 7247 -5249 48 7248 7249 -5250 48 7248 7250 -5251 48 7251 7252 -5252 48 7251 7253 -5253 48 7254 7255 -5254 48 7254 7256 -5255 48 7257 7258 -5256 48 7257 7259 -5257 48 7260 7261 -5258 48 7260 7262 -5259 48 7263 7264 -5260 48 7263 7265 -5261 48 7266 7267 -5262 48 7266 7268 -5263 48 7269 7270 -5264 48 7269 7271 -5265 48 7272 7273 -5266 48 7272 7274 -5267 48 7275 7276 -5268 48 7275 7277 -5269 48 7278 7279 -5270 48 7278 7280 -5271 48 7281 7282 -5272 48 7281 7283 -5273 48 7284 7285 -5274 48 7284 7286 -5275 48 7287 7288 -5276 48 7287 7289 -5277 48 7290 7291 -5278 48 7290 7292 -5279 48 7293 7294 -5280 48 7293 7295 -5281 48 7296 7297 -5282 48 7296 7298 -5283 48 7299 7300 -5284 48 7299 7301 -5285 48 7302 7303 -5286 48 7302 7304 -5287 48 7305 7306 -5288 48 7305 7307 -5289 48 7308 7309 -5290 48 7308 7310 -5291 48 7311 7312 -5292 48 7311 7313 -5293 48 7314 7315 -5294 48 7314 7316 -5295 48 7317 7318 -5296 48 7317 7319 -5297 48 7320 7321 -5298 48 7320 7322 -5299 48 7323 7324 -5300 48 7323 7325 -5301 48 7326 7327 -5302 48 7326 7328 -5303 48 7329 7330 -5304 48 7329 7331 -5305 48 7332 7333 -5306 48 7332 7334 -5307 48 7335 7336 -5308 48 7335 7337 -5309 48 7338 7339 -5310 48 7338 7340 -5311 48 7341 7342 -5312 48 7341 7343 -5313 48 7344 7345 -5314 48 7344 7346 -5315 48 7347 7348 -5316 48 7347 7349 -5317 48 7350 7351 -5318 48 7350 7352 -5319 48 7353 7354 -5320 48 7353 7355 -5321 48 7356 7357 -5322 48 7356 7358 -5323 48 7359 7360 -5324 48 7359 7361 -5325 48 7362 7363 -5326 48 7362 7364 -5327 48 7365 7366 -5328 48 7365 7367 -5329 48 7368 7369 -5330 48 7368 7370 -5331 48 7371 7372 -5332 48 7371 7373 -5333 48 7374 7375 -5334 48 7374 7376 -5335 48 7377 7378 -5336 48 7377 7379 -5337 48 7380 7381 -5338 48 7380 7382 -5339 48 7383 7384 -5340 48 7383 7385 -5341 48 7386 7387 -5342 48 7386 7388 -5343 48 7389 7390 -5344 48 7389 7391 -5345 48 7392 7393 -5346 48 7392 7394 -5347 48 7395 7396 -5348 48 7395 7397 -5349 48 7398 7399 -5350 48 7398 7400 -5351 48 7401 7402 -5352 48 7401 7403 -5353 48 7404 7405 -5354 48 7404 7406 -5355 48 7407 7408 -5356 48 7407 7409 -5357 48 7410 7411 -5358 48 7410 7412 -5359 48 7413 7414 -5360 48 7413 7415 -5361 48 7416 7417 -5362 48 7416 7418 -5363 48 7419 7420 -5364 48 7419 7421 -5365 48 7422 7423 -5366 48 7422 7424 -5367 48 7425 7426 -5368 48 7425 7427 -5369 48 7428 7429 -5370 48 7428 7430 -5371 48 7431 7432 -5372 48 7431 7433 -5373 48 7434 7435 -5374 48 7434 7436 -5375 48 7437 7438 -5376 48 7437 7439 -5377 48 7440 7441 -5378 48 7440 7442 -5379 48 7443 7444 -5380 48 7443 7445 -5381 48 7446 7447 -5382 48 7446 7448 -5383 48 7449 7450 -5384 48 7449 7451 -5385 48 7452 7453 -5386 48 7452 7454 -5387 48 7455 7456 -5388 48 7455 7457 -5389 48 7458 7459 -5390 48 7458 7460 -5391 48 7461 7462 -5392 48 7461 7463 -5393 48 7464 7465 -5394 48 7464 7466 -5395 48 7467 7468 -5396 48 7467 7469 -5397 48 7470 7471 -5398 48 7470 7472 -5399 48 7473 7474 -5400 48 7473 7475 -5401 48 7476 7477 -5402 48 7476 7478 -5403 48 7479 7480 -5404 48 7479 7481 -5405 48 7482 7483 -5406 48 7482 7484 -5407 48 7485 7486 -5408 48 7485 7487 -5409 48 7488 7489 -5410 48 7488 7490 -5411 48 7491 7492 -5412 48 7491 7493 -5413 48 7494 7495 -5414 48 7494 7496 -5415 48 7497 7498 -5416 48 7497 7499 -5417 48 7500 7501 -5418 48 7500 7502 -5419 48 7503 7504 -5420 48 7503 7505 -5421 48 7506 7507 -5422 48 7506 7508 -5423 48 7509 7510 -5424 48 7509 7511 -5425 48 7512 7513 -5426 48 7512 7514 -5427 48 7515 7516 -5428 48 7515 7517 -5429 48 7518 7519 -5430 48 7518 7520 -5431 48 7521 7522 -5432 48 7521 7523 -5433 48 7524 7525 -5434 48 7524 7526 -5435 48 7527 7528 -5436 48 7527 7529 -5437 48 7530 7531 -5438 48 7530 7532 -5439 48 7533 7534 -5440 48 7533 7535 -5441 48 7536 7537 -5442 48 7536 7538 -5443 48 7539 7540 -5444 48 7539 7541 -5445 48 7542 7543 -5446 48 7542 7544 -5447 48 7545 7546 -5448 48 7545 7547 -5449 48 7548 7549 -5450 48 7548 7550 -5451 48 7551 7552 -5452 48 7551 7553 -5453 48 7554 7555 -5454 48 7554 7556 -5455 48 7557 7558 -5456 48 7557 7559 -5457 48 7560 7561 -5458 48 7560 7562 -5459 48 7563 7564 -5460 48 7563 7565 -5461 48 7566 7567 -5462 48 7566 7568 -5463 48 7569 7570 -5464 48 7569 7571 -5465 48 7572 7573 -5466 48 7572 7574 -5467 48 7575 7576 -5468 48 7575 7577 -5469 48 7578 7579 -5470 48 7578 7580 -5471 48 7581 7582 -5472 48 7581 7583 -5473 48 7584 7585 -5474 48 7584 7586 -5475 48 7587 7588 -5476 48 7587 7589 -5477 48 7590 7591 -5478 48 7590 7592 -5479 48 7593 7594 -5480 48 7593 7595 -5481 48 7596 7597 -5482 48 7596 7598 -5483 48 7599 7600 -5484 48 7599 7601 -5485 48 7602 7603 -5486 48 7602 7604 -5487 48 7605 7606 -5488 48 7605 7607 -5489 48 7608 7609 -5490 48 7608 7610 -5491 48 7611 7612 -5492 48 7611 7613 -5493 48 7614 7615 -5494 48 7614 7616 -5495 48 7617 7618 -5496 48 7617 7619 -5497 48 7620 7621 -5498 48 7620 7622 -5499 48 7623 7624 -5500 48 7623 7625 -5501 48 7626 7627 -5502 48 7626 7628 -5503 48 7629 7630 -5504 48 7629 7631 -5505 48 7632 7633 -5506 48 7632 7634 -5507 48 7635 7636 -5508 48 7635 7637 -5509 48 7638 7639 -5510 48 7638 7640 -5511 48 7641 7642 -5512 48 7641 7643 -5513 48 7644 7645 -5514 48 7644 7646 -5515 48 7647 7648 -5516 48 7647 7649 -5517 48 7650 7651 -5518 48 7650 7652 -5519 48 7653 7654 -5520 48 7653 7655 -5521 48 7656 7657 -5522 48 7656 7658 -5523 48 7659 7660 -5524 48 7659 7661 -5525 48 7662 7663 -5526 48 7662 7664 -5527 48 7665 7666 -5528 48 7665 7667 -5529 48 7668 7669 -5530 48 7668 7670 -5531 48 7671 7672 -5532 48 7671 7673 -5533 48 7674 7675 -5534 48 7674 7676 -5535 48 7677 7678 -5536 48 7677 7679 -5537 48 7680 7681 -5538 48 7680 7682 -5539 48 7683 7684 -5540 48 7683 7685 -5541 48 7686 7687 -5542 48 7686 7688 -5543 48 7689 7690 -5544 48 7689 7691 -5545 48 7692 7693 -5546 48 7692 7694 -5547 48 7695 7696 -5548 48 7695 7697 -5549 48 7698 7699 -5550 48 7698 7700 -5551 48 7701 7702 -5552 48 7701 7703 -5553 48 7704 7705 -5554 48 7704 7706 -5555 48 7707 7708 -5556 48 7707 7709 -5557 48 7710 7711 -5558 48 7710 7712 -5559 48 7713 7714 -5560 48 7713 7715 -5561 48 7716 7717 -5562 48 7716 7718 -5563 48 7719 7720 -5564 48 7719 7721 -5565 48 7722 7723 -5566 48 7722 7724 -5567 48 7725 7726 -5568 48 7725 7727 -5569 48 7728 7729 -5570 48 7728 7730 -5571 48 7731 7732 -5572 48 7731 7733 -5573 48 7734 7735 -5574 48 7734 7736 -5575 48 7737 7738 -5576 48 7737 7739 -5577 48 7740 7741 -5578 48 7740 7742 -5579 48 7743 7744 -5580 48 7743 7745 -5581 48 7746 7747 -5582 48 7746 7748 -5583 48 7749 7750 -5584 48 7749 7751 -5585 48 7752 7753 -5586 48 7752 7754 -5587 48 7755 7756 -5588 48 7755 7757 -5589 48 7758 7759 -5590 48 7758 7760 -5591 48 7761 7762 -5592 48 7761 7763 -5593 48 7764 7765 -5594 48 7764 7766 -5595 48 7767 7768 -5596 48 7767 7769 -5597 48 7770 7771 -5598 48 7770 7772 -5599 48 7773 7774 -5600 48 7773 7775 -5601 48 7776 7777 -5602 48 7776 7778 -5603 48 7779 7780 -5604 48 7779 7781 -5605 48 7782 7783 -5606 48 7782 7784 -5607 48 7785 7786 -5608 48 7785 7787 -5609 48 7788 7789 -5610 48 7788 7790 -5611 48 7791 7792 -5612 48 7791 7793 -5613 48 7794 7795 -5614 48 7794 7796 -5615 48 7797 7798 -5616 48 7797 7799 -5617 48 7800 7801 -5618 48 7800 7802 -5619 48 7803 7804 -5620 48 7803 7805 -5621 48 7806 7807 -5622 48 7806 7808 -5623 48 7809 7810 -5624 48 7809 7811 -5625 48 7812 7813 -5626 48 7812 7814 -5627 48 7815 7816 -5628 48 7815 7817 -5629 48 7818 7819 -5630 48 7818 7820 -5631 48 7821 7822 -5632 48 7821 7823 -5633 48 7824 7825 -5634 48 7824 7826 -5635 48 7827 7828 -5636 48 7827 7829 -5637 48 7830 7831 -5638 48 7830 7832 -5639 48 7833 7834 -5640 48 7833 7835 -5641 48 7836 7837 -5642 48 7836 7838 -5643 48 7839 7840 -5644 48 7839 7841 -5645 48 7842 7843 -5646 48 7842 7844 -5647 48 7845 7846 -5648 48 7845 7847 -5649 48 7848 7849 -5650 48 7848 7850 -5651 48 7851 7852 -5652 48 7851 7853 -5653 48 7854 7855 -5654 48 7854 7856 -5655 48 7857 7858 -5656 48 7857 7859 -5657 48 7860 7861 -5658 48 7860 7862 -5659 48 7863 7864 -5660 48 7863 7865 -5661 48 7866 7867 -5662 48 7866 7868 -5663 48 7869 7870 -5664 48 7869 7871 -5665 48 7872 7873 -5666 48 7872 7874 -5667 48 7875 7876 -5668 48 7875 7877 -5669 48 7878 7879 -5670 48 7878 7880 -5671 48 7881 7882 -5672 48 7881 7883 -5673 48 7884 7885 -5674 48 7884 7886 -5675 48 7887 7888 -5676 48 7887 7889 -5677 48 7890 7891 -5678 48 7890 7892 -5679 48 7893 7894 -5680 48 7893 7895 -5681 48 7896 7897 -5682 48 7896 7898 -5683 48 7899 7900 -5684 48 7899 7901 -5685 48 7902 7903 -5686 48 7902 7904 -5687 48 7905 7906 -5688 48 7905 7907 -5689 48 7908 7909 -5690 48 7908 7910 -5691 48 7911 7912 -5692 48 7911 7913 -5693 48 7914 7915 -5694 48 7914 7916 -5695 48 7917 7918 -5696 48 7917 7919 -5697 48 7920 7921 -5698 48 7920 7922 -5699 48 7923 7924 -5700 48 7923 7925 -5701 48 7926 7927 -5702 48 7926 7928 -5703 48 7929 7930 -5704 48 7929 7931 -5705 48 7932 7933 -5706 48 7932 7934 -5707 48 7935 7936 -5708 48 7935 7937 -5709 48 7938 7939 -5710 48 7938 7940 -5711 48 7941 7942 -5712 48 7941 7943 -5713 48 7944 7945 -5714 48 7944 7946 -5715 48 7947 7948 -5716 48 7947 7949 -5717 48 7950 7951 -5718 48 7950 7952 -5719 48 7953 7954 -5720 48 7953 7955 -5721 48 7956 7957 -5722 48 7956 7958 -5723 48 7959 7960 -5724 48 7959 7961 -5725 48 7962 7963 -5726 48 7962 7964 -5727 48 7965 7966 -5728 48 7965 7967 -5729 48 7968 7969 -5730 48 7968 7970 -5731 48 7971 7972 -5732 48 7971 7973 -5733 48 7974 7975 -5734 48 7974 7976 -5735 48 7977 7978 -5736 48 7977 7979 -5737 48 7980 7981 -5738 48 7980 7982 -5739 48 7983 7984 -5740 48 7983 7985 -5741 48 7986 7987 -5742 48 7986 7988 -5743 48 7989 7990 -5744 48 7989 7991 -5745 48 7992 7993 -5746 48 7992 7994 -5747 48 7995 7996 -5748 48 7995 7997 -5749 48 7998 7999 -5750 48 7998 8000 -5751 48 8001 8002 -5752 48 8001 8003 -5753 48 8004 8005 -5754 48 8004 8006 -5755 48 8007 8008 -5756 48 8007 8009 -5757 48 8010 8011 -5758 48 8010 8012 -5759 48 8013 8014 -5760 48 8013 8015 -5761 48 8016 8017 -5762 48 8016 8018 -5763 48 8019 8020 -5764 48 8019 8021 -5765 48 8022 8023 -5766 48 8022 8024 -5767 48 8025 8026 -5768 48 8025 8027 -5769 48 8028 8029 -5770 48 8028 8030 -5771 48 8031 8032 -5772 48 8031 8033 -5773 48 8034 8035 -5774 48 8034 8036 -5775 48 8037 8038 -5776 48 8037 8039 -5777 48 8040 8041 -5778 48 8040 8042 -5779 48 8043 8044 -5780 48 8043 8045 -5781 48 8046 8047 -5782 48 8046 8048 -5783 48 8049 8050 -5784 48 8049 8051 -5785 48 8052 8053 -5786 48 8052 8054 -5787 48 8055 8056 -5788 48 8055 8057 -5789 48 8058 8059 -5790 48 8058 8060 -5791 48 8061 8062 -5792 48 8061 8063 -5793 48 8064 8065 -5794 48 8064 8066 -5795 48 8067 8068 -5796 48 8067 8069 -5797 48 8070 8071 -5798 48 8070 8072 -5799 48 8073 8074 -5800 48 8073 8075 -5801 48 8076 8077 -5802 48 8076 8078 -5803 48 8079 8080 -5804 48 8079 8081 -5805 48 8082 8083 -5806 48 8082 8084 -5807 48 8085 8086 -5808 48 8085 8087 -5809 48 8088 8089 -5810 48 8088 8090 -5811 48 8091 8092 -5812 48 8091 8093 -5813 48 8094 8095 -5814 48 8094 8096 -5815 48 8097 8098 -5816 48 8097 8099 -5817 48 8100 8101 -5818 48 8100 8102 -5819 48 8103 8104 -5820 48 8103 8105 -5821 48 8106 8107 -5822 48 8106 8108 -5823 48 8109 8110 -5824 48 8109 8111 -5825 48 8112 8113 -5826 48 8112 8114 -5827 48 8115 8116 -5828 48 8115 8117 -5829 48 8118 8119 -5830 48 8118 8120 -5831 48 8121 8122 -5832 48 8121 8123 -5833 48 8124 8125 -5834 48 8124 8126 -5835 48 8127 8128 -5836 48 8127 8129 -5837 48 8130 8131 -5838 48 8130 8132 -5839 48 8133 8134 -5840 48 8133 8135 -5841 48 8136 8137 -5842 48 8136 8138 -5843 48 8139 8140 -5844 48 8139 8141 -5845 48 8142 8143 -5846 48 8142 8144 -5847 48 8145 8146 -5848 48 8145 8147 -5849 48 8148 8149 -5850 48 8148 8150 -5851 48 8151 8152 -5852 48 8151 8153 -5853 48 8154 8155 -5854 48 8154 8156 -5855 48 8157 8158 -5856 48 8157 8159 -5857 48 8160 8161 -5858 48 8160 8162 -5859 48 8163 8164 -5860 48 8163 8165 -5861 48 8166 8167 -5862 48 8166 8168 -5863 48 8169 8170 -5864 48 8169 8171 -5865 48 8172 8173 -5866 48 8172 8174 -5867 48 8175 8176 -5868 48 8175 8177 -5869 48 8178 8179 -5870 48 8178 8180 -5871 48 8181 8182 -5872 48 8181 8183 -5873 48 8184 8185 -5874 48 8184 8186 -5875 48 8187 8188 -5876 48 8187 8189 -5877 48 8190 8191 -5878 48 8190 8192 -5879 48 8193 8194 -5880 48 8193 8195 -5881 48 8196 8197 -5882 48 8196 8198 -5883 48 8199 8200 -5884 48 8199 8201 -5885 48 8202 8203 -5886 48 8202 8204 -5887 48 8205 8206 -5888 48 8205 8207 -5889 48 8208 8209 -5890 48 8208 8210 -5891 48 8211 8212 -5892 48 8211 8213 -5893 48 8214 8215 -5894 48 8214 8216 -5895 48 8217 8218 -5896 48 8217 8219 -5897 48 8220 8221 -5898 48 8220 8222 -5899 48 8223 8224 -5900 48 8223 8225 -5901 48 8226 8227 -5902 48 8226 8228 -5903 48 8229 8230 -5904 48 8229 8231 -5905 48 8232 8233 -5906 48 8232 8234 -5907 48 8235 8236 -5908 48 8235 8237 -5909 48 8238 8239 -5910 48 8238 8240 -5911 48 8241 8242 -5912 48 8241 8243 -5913 48 8244 8245 -5914 48 8244 8246 -5915 48 8247 8248 -5916 48 8247 8249 -5917 48 8250 8251 -5918 48 8250 8252 -5919 48 8253 8254 -5920 48 8253 8255 -5921 48 8256 8257 -5922 48 8256 8258 -5923 48 8259 8260 -5924 48 8259 8261 -5925 48 8262 8263 -5926 48 8262 8264 -5927 48 8265 8266 -5928 48 8265 8267 -5929 48 8268 8269 -5930 48 8268 8270 -5931 48 8271 8272 -5932 48 8271 8273 -5933 48 8274 8275 -5934 48 8274 8276 -5935 48 8277 8278 -5936 48 8277 8279 -5937 48 8280 8281 -5938 48 8280 8282 -5939 48 8283 8284 -5940 48 8283 8285 -5941 48 8286 8287 -5942 48 8286 8288 -5943 48 8289 8290 -5944 48 8289 8291 -5945 48 8292 8293 -5946 48 8292 8294 -5947 48 8295 8296 -5948 48 8295 8297 -5949 48 8298 8299 -5950 48 8298 8300 -5951 48 8301 8302 -5952 48 8301 8303 -5953 48 8304 8305 -5954 48 8304 8306 -5955 48 8307 8308 -5956 48 8307 8309 -5957 48 8310 8311 -5958 48 8310 8312 -5959 48 8313 8314 -5960 48 8313 8315 -5961 48 8316 8317 -5962 48 8316 8318 -5963 48 8319 8320 -5964 48 8319 8321 -5965 48 8322 8323 -5966 48 8322 8324 -5967 48 8325 8326 -5968 48 8325 8327 -5969 48 8328 8329 -5970 48 8328 8330 -5971 48 8331 8332 -5972 48 8331 8333 -5973 48 8334 8335 -5974 48 8334 8336 -5975 48 8337 8338 -5976 48 8337 8339 -5977 48 8340 8341 -5978 48 8340 8342 -5979 48 8343 8344 -5980 48 8343 8345 -5981 48 8346 8347 -5982 48 8346 8348 -5983 48 8349 8350 -5984 48 8349 8351 -5985 48 8352 8353 -5986 48 8352 8354 -5987 48 8355 8356 -5988 48 8355 8357 -5989 48 8358 8359 -5990 48 8358 8360 -5991 48 8361 8362 -5992 48 8361 8363 -5993 48 8364 8365 -5994 48 8364 8366 -5995 48 8367 8368 -5996 48 8367 8369 -5997 48 8370 8371 -5998 48 8370 8372 -5999 48 8373 8374 -6000 48 8373 8375 -6001 48 8376 8377 -6002 48 8376 8378 -6003 48 8379 8380 -6004 48 8379 8381 -6005 48 8382 8383 -6006 48 8382 8384 -6007 48 8385 8386 -6008 48 8385 8387 -6009 48 8388 8389 -6010 48 8388 8390 -6011 48 8391 8392 -6012 48 8391 8393 -6013 48 8394 8395 -6014 48 8394 8396 -6015 48 8397 8398 -6016 48 8397 8399 -6017 48 8400 8401 -6018 48 8400 8402 -6019 48 8403 8404 -6020 48 8403 8405 -6021 48 8406 8407 -6022 48 8406 8408 -6023 48 8409 8410 -6024 48 8409 8411 -6025 48 8412 8413 -6026 48 8412 8414 -6027 48 8415 8416 -6028 48 8415 8417 -6029 48 8418 8419 -6030 48 8418 8420 -6031 48 8421 8422 -6032 48 8421 8423 -6033 48 8424 8425 -6034 48 8424 8426 -6035 48 8427 8428 -6036 48 8427 8429 -6037 48 8430 8431 -6038 48 8430 8432 -6039 48 8433 8434 -6040 48 8433 8435 -6041 48 8436 8437 -6042 48 8436 8438 -6043 48 8439 8440 -6044 48 8439 8441 -6045 48 8442 8443 -6046 48 8442 8444 -6047 48 8445 8446 -6048 48 8445 8447 -6049 48 8448 8449 -6050 48 8448 8450 -6051 48 8451 8452 -6052 48 8451 8453 -6053 48 8454 8455 -6054 48 8454 8456 -6055 48 8457 8458 -6056 48 8457 8459 -6057 48 8460 8461 -6058 48 8460 8462 -6059 48 8463 8464 -6060 48 8463 8465 -6061 48 8466 8467 -6062 48 8466 8468 -6063 48 8469 8470 -6064 48 8469 8471 -6065 48 8472 8473 -6066 48 8472 8474 -6067 48 8475 8476 -6068 48 8475 8477 -6069 48 8478 8479 -6070 48 8478 8480 -6071 48 8481 8482 -6072 48 8481 8483 -6073 48 8484 8485 -6074 48 8484 8486 -6075 48 8487 8488 -6076 48 8487 8489 -6077 48 8490 8491 -6078 48 8490 8492 -6079 48 8493 8494 -6080 48 8493 8495 -6081 48 8496 8497 -6082 48 8496 8498 -6083 48 8499 8500 -6084 48 8499 8501 -6085 48 8502 8503 -6086 48 8502 8504 -6087 48 8505 8506 -6088 48 8505 8507 -6089 48 8508 8509 -6090 48 8508 8510 -6091 48 8511 8512 -6092 48 8511 8513 -6093 48 8514 8515 -6094 48 8514 8516 -6095 48 8517 8518 -6096 48 8517 8519 -6097 48 8520 8521 -6098 48 8520 8522 -6099 48 8523 8524 -6100 48 8523 8525 -6101 48 8526 8527 -6102 48 8526 8528 -6103 48 8529 8530 -6104 48 8529 8531 -6105 48 8532 8533 -6106 48 8532 8534 -6107 48 8535 8536 -6108 48 8535 8537 -6109 48 8538 8539 -6110 48 8538 8540 -6111 48 8541 8542 -6112 48 8541 8543 -6113 48 8544 8545 -6114 48 8544 8546 -6115 48 8547 8548 -6116 48 8547 8549 -6117 48 8550 8551 -6118 48 8550 8552 -6119 48 8553 8554 -6120 48 8553 8555 -6121 48 8556 8557 -6122 48 8556 8558 -6123 48 8559 8560 -6124 48 8559 8561 -6125 48 8562 8563 -6126 48 8562 8564 -6127 48 8565 8566 -6128 48 8565 8567 -6129 48 8568 8569 -6130 48 8568 8570 -6131 48 8571 8572 -6132 48 8571 8573 -6133 48 8574 8575 -6134 48 8574 8576 -6135 48 8577 8578 -6136 48 8577 8579 -6137 48 8580 8581 -6138 48 8580 8582 -6139 48 8583 8584 -6140 48 8583 8585 -6141 48 8586 8587 -6142 48 8586 8588 -6143 48 8589 8590 -6144 48 8589 8591 -6145 48 8592 8593 -6146 48 8592 8594 -6147 48 8595 8596 -6148 48 8595 8597 -6149 48 8598 8599 -6150 48 8598 8600 -6151 48 8601 8602 -6152 48 8601 8603 -6153 48 8604 8605 -6154 48 8604 8606 -6155 48 8607 8608 -6156 48 8607 8609 -6157 48 8610 8611 -6158 48 8610 8612 -6159 48 8613 8614 -6160 48 8613 8615 -6161 48 8616 8617 -6162 48 8616 8618 -6163 48 8619 8620 -6164 48 8619 8621 -6165 48 8622 8623 -6166 48 8622 8624 -6167 48 8625 8626 -6168 48 8625 8627 -6169 48 8628 8629 -6170 48 8628 8630 -6171 48 8631 8632 -6172 48 8631 8633 -6173 48 8634 8635 -6174 48 8634 8636 -6175 48 8637 8638 -6176 48 8637 8639 -6177 48 8640 8641 -6178 48 8640 8642 -6179 48 8643 8644 -6180 48 8643 8645 -6181 48 8646 8647 -6182 48 8646 8648 -6183 48 8649 8650 -6184 48 8649 8651 -6185 48 8652 8653 -6186 48 8652 8654 -6187 48 8655 8656 -6188 48 8655 8657 -6189 48 8658 8659 -6190 48 8658 8660 -6191 48 8661 8662 -6192 48 8661 8663 -6193 48 8664 8665 -6194 48 8664 8666 -6195 48 8667 8668 -6196 48 8667 8669 -6197 48 8670 8671 -6198 48 8670 8672 -6199 48 8673 8674 -6200 48 8673 8675 -6201 48 8676 8677 -6202 48 8676 8678 -6203 48 8679 8680 -6204 48 8679 8681 -6205 48 8682 8683 -6206 48 8682 8684 -6207 48 8685 8686 -6208 48 8685 8687 -6209 48 8688 8689 -6210 48 8688 8690 -6211 48 8691 8692 -6212 48 8691 8693 -6213 48 8694 8695 -6214 48 8694 8696 -6215 48 8697 8698 -6216 48 8697 8699 -6217 48 8700 8701 -6218 48 8700 8702 -6219 48 8703 8704 -6220 48 8703 8705 -6221 48 8706 8707 -6222 48 8706 8708 -6223 48 8709 8710 -6224 48 8709 8711 -6225 48 8712 8713 -6226 48 8712 8714 -6227 48 8715 8716 -6228 48 8715 8717 -6229 48 8718 8719 -6230 48 8718 8720 -6231 48 8721 8722 -6232 48 8721 8723 -6233 48 8724 8725 -6234 48 8724 8726 -6235 48 8727 8728 -6236 48 8727 8729 -6237 48 8730 8731 -6238 48 8730 8732 -6239 48 8733 8734 -6240 48 8733 8735 -6241 48 8736 8737 -6242 48 8736 8738 -6243 48 8739 8740 -6244 48 8739 8741 -6245 48 8742 8743 -6246 48 8742 8744 -6247 48 8745 8746 -6248 48 8745 8747 -6249 48 8748 8749 -6250 48 8748 8750 -6251 48 8751 8752 -6252 48 8751 8753 -6253 48 8754 8755 -6254 48 8754 8756 -6255 48 8757 8758 -6256 48 8757 8759 -6257 48 8760 8761 -6258 48 8760 8762 -6259 48 8763 8764 -6260 48 8763 8765 -6261 48 8766 8767 -6262 48 8766 8768 -6263 48 8769 8770 -6264 48 8769 8771 -6265 48 8772 8773 -6266 48 8772 8774 -6267 48 8775 8776 -6268 48 8775 8777 -6269 48 8778 8779 -6270 48 8778 8780 -6271 48 8781 8782 -6272 48 8781 8783 -6273 48 8784 8785 -6274 48 8784 8786 -6275 48 8787 8788 -6276 48 8787 8789 -6277 48 8790 8791 -6278 48 8790 8792 -6279 48 8793 8794 -6280 48 8793 8795 -6281 48 8796 8797 -6282 48 8796 8798 -6283 48 8799 8800 -6284 48 8799 8801 -6285 48 8802 8803 -6286 48 8802 8804 -6287 48 8805 8806 -6288 48 8805 8807 -6289 48 8808 8809 -6290 48 8808 8810 -6291 48 8811 8812 -6292 48 8811 8813 -6293 48 8814 8815 -6294 48 8814 8816 -6295 48 8817 8818 -6296 48 8817 8819 -6297 48 8820 8821 -6298 48 8820 8822 -6299 48 8823 8824 -6300 48 8823 8825 -6301 48 8826 8827 -6302 48 8826 8828 -6303 48 8829 8830 -6304 48 8829 8831 -6305 48 8832 8833 -6306 48 8832 8834 -6307 48 8835 8836 -6308 48 8835 8837 -6309 48 8838 8839 -6310 48 8838 8840 -6311 48 8841 8842 -6312 48 8841 8843 -6313 48 8844 8845 -6314 48 8844 8846 -6315 48 8847 8848 -6316 48 8847 8849 -6317 48 8850 8851 -6318 48 8850 8852 -6319 48 8853 8854 -6320 48 8853 8855 -6321 48 8856 8857 -6322 48 8856 8858 -6323 48 8859 8860 -6324 48 8859 8861 -6325 48 8862 8863 -6326 48 8862 8864 -6327 48 8865 8866 -6328 48 8865 8867 -6329 48 8868 8869 -6330 48 8868 8870 -6331 48 8871 8872 -6332 48 8871 8873 -6333 48 8874 8875 -6334 48 8874 8876 -6335 48 8877 8878 -6336 48 8877 8879 -6337 48 8880 8881 -6338 48 8880 8882 -6339 48 8883 8884 -6340 48 8883 8885 -6341 48 8886 8887 -6342 48 8886 8888 -6343 48 8889 8890 -6344 48 8889 8891 -6345 48 8892 8893 -6346 48 8892 8894 -6347 48 8895 8896 -6348 48 8895 8897 -6349 48 8898 8899 -6350 48 8898 8900 -6351 48 8901 8902 -6352 48 8901 8903 -6353 48 8904 8905 -6354 48 8904 8906 -6355 48 8907 8908 -6356 48 8907 8909 -6357 48 8910 8911 -6358 48 8910 8912 -6359 48 8913 8914 -6360 48 8913 8915 -6361 48 8916 8917 -6362 48 8916 8918 -6363 48 8919 8920 -6364 48 8919 8921 -6365 48 8922 8923 -6366 48 8922 8924 -6367 48 8925 8926 -6368 48 8925 8927 -6369 48 8928 8929 -6370 48 8928 8930 -6371 48 8931 8932 -6372 48 8931 8933 -6373 48 8934 8935 -6374 48 8934 8936 -6375 48 8937 8938 -6376 48 8937 8939 -6377 48 8940 8941 -6378 48 8940 8942 -6379 48 8943 8944 -6380 48 8943 8945 -6381 48 8946 8947 -6382 48 8946 8948 -6383 48 8949 8950 -6384 48 8949 8951 -6385 48 8952 8953 -6386 48 8952 8954 -6387 48 8955 8956 -6388 48 8955 8957 -6389 48 8958 8959 -6390 48 8958 8960 -6391 48 8961 8962 -6392 48 8961 8963 -6393 48 8964 8965 -6394 48 8964 8966 -6395 48 8967 8968 -6396 48 8967 8969 -6397 48 8970 8971 -6398 48 8970 8972 -6399 48 8973 8974 -6400 48 8973 8975 -6401 48 8976 8977 -6402 48 8976 8978 -6403 48 8979 8980 -6404 48 8979 8981 -6405 48 8982 8983 -6406 48 8982 8984 -6407 48 8985 8986 -6408 48 8985 8987 -6409 48 8988 8989 -6410 48 8988 8990 -6411 48 8991 8992 -6412 48 8991 8993 -6413 48 8994 8995 -6414 48 8994 8996 -6415 48 8997 8998 -6416 48 8997 8999 -6417 48 9000 9001 -6418 48 9000 9002 -6419 48 9003 9004 -6420 48 9003 9005 -6421 48 9006 9007 -6422 48 9006 9008 -6423 48 9009 9010 -6424 48 9009 9011 -6425 48 9012 9013 -6426 48 9012 9014 -6427 48 9015 9016 -6428 48 9015 9017 -6429 48 9018 9019 -6430 48 9018 9020 -6431 48 9021 9022 -6432 48 9021 9023 -6433 48 9024 9025 -6434 48 9024 9026 -6435 48 9027 9028 -6436 48 9027 9029 -6437 48 9030 9031 -6438 48 9030 9032 -6439 48 9033 9034 -6440 48 9033 9035 -6441 48 9036 9037 -6442 48 9036 9038 -6443 48 9039 9040 -6444 48 9039 9041 -6445 48 9042 9043 -6446 48 9042 9044 -6447 48 9045 9046 -6448 48 9045 9047 -6449 48 9048 9049 -6450 48 9048 9050 -6451 48 9051 9052 -6452 48 9051 9053 -6453 48 9054 9055 -6454 48 9054 9056 -6455 48 9057 9058 -6456 48 9057 9059 -6457 48 9060 9061 -6458 48 9060 9062 -6459 48 9063 9064 -6460 48 9063 9065 -6461 48 9066 9067 -6462 48 9066 9068 -6463 48 9069 9070 -6464 48 9069 9071 -6465 48 9072 9073 -6466 48 9072 9074 -6467 48 9075 9076 -6468 48 9075 9077 -6469 48 9078 9079 -6470 48 9078 9080 -6471 48 9081 9082 -6472 48 9081 9083 -6473 48 9084 9085 -6474 48 9084 9086 -6475 48 9087 9088 -6476 48 9087 9089 -6477 48 9090 9091 -6478 48 9090 9092 -6479 48 9093 9094 -6480 48 9093 9095 -6481 48 9096 9097 -6482 48 9096 9098 -6483 48 9099 9100 -6484 48 9099 9101 -6485 48 9102 9103 -6486 48 9102 9104 -6487 48 9105 9106 -6488 48 9105 9107 -6489 48 9108 9109 -6490 48 9108 9110 -6491 48 9111 9112 -6492 48 9111 9113 -6493 48 9114 9115 -6494 48 9114 9116 -6495 48 9117 9118 -6496 48 9117 9119 -6497 48 9120 9121 -6498 48 9120 9122 -6499 48 9123 9124 -6500 48 9123 9125 -6501 48 9126 9127 -6502 48 9126 9128 -6503 48 9129 9130 -6504 48 9129 9131 -6505 48 9132 9133 -6506 48 9132 9134 -6507 48 9135 9136 -6508 48 9135 9137 -6509 48 9138 9139 -6510 48 9138 9140 -6511 48 9141 9142 -6512 48 9141 9143 -6513 48 9144 9145 -6514 48 9144 9146 -6515 48 9147 9148 -6516 48 9147 9149 -6517 48 9150 9151 -6518 48 9150 9152 -6519 48 9153 9154 -6520 48 9153 9155 -6521 48 9156 9157 -6522 48 9156 9158 -6523 48 9159 9160 -6524 48 9159 9161 -6525 48 9162 9163 -6526 48 9162 9164 -6527 48 9165 9166 -6528 48 9165 9167 -6529 48 9168 9169 -6530 48 9168 9170 -6531 48 9171 9172 -6532 48 9171 9173 -6533 48 9174 9175 -6534 48 9174 9176 -6535 48 9177 9178 -6536 48 9177 9179 -6537 48 9180 9181 -6538 48 9180 9182 -6539 48 9183 9184 -6540 48 9183 9185 -6541 48 9186 9187 -6542 48 9186 9188 -6543 48 9189 9190 -6544 48 9189 9191 -6545 48 9192 9193 -6546 48 9192 9194 -6547 48 9195 9196 -6548 48 9195 9197 -6549 48 9198 9199 -6550 48 9198 9200 -6551 48 9201 9202 -6552 48 9201 9203 -6553 48 9204 9205 -6554 48 9204 9206 -6555 48 9207 9208 -6556 48 9207 9209 -6557 48 9210 9211 -6558 48 9210 9212 -6559 48 9213 9214 -6560 48 9213 9215 -6561 48 9216 9217 -6562 48 9216 9218 -6563 48 9219 9220 -6564 48 9219 9221 -6565 48 9222 9223 -6566 48 9222 9224 -6567 48 9225 9226 -6568 48 9225 9227 -6569 48 9228 9229 -6570 48 9228 9230 -6571 48 9231 9232 -6572 48 9231 9233 -6573 48 9234 9235 -6574 48 9234 9236 -6575 48 9237 9238 -6576 48 9237 9239 -6577 48 9240 9241 -6578 48 9240 9242 -6579 48 9243 9244 -6580 48 9243 9245 -6581 48 9246 9247 -6582 48 9246 9248 -6583 48 9249 9250 -6584 48 9249 9251 -6585 48 9252 9253 -6586 48 9252 9254 -6587 48 9255 9256 -6588 48 9255 9257 -6589 48 9258 9259 -6590 48 9258 9260 -6591 48 9261 9262 -6592 48 9261 9263 -6593 48 9264 9265 -6594 48 9264 9266 -6595 48 9267 9268 -6596 48 9267 9269 -6597 48 9270 9271 -6598 48 9270 9272 -6599 48 9273 9274 -6600 48 9273 9275 -6601 48 9276 9277 -6602 48 9276 9278 -6603 48 9279 9280 -6604 48 9279 9281 -6605 48 9282 9283 -6606 48 9282 9284 -6607 48 9285 9286 -6608 48 9285 9287 -6609 48 9288 9289 -6610 48 9288 9290 -6611 48 9291 9292 -6612 48 9291 9293 -6613 48 9294 9295 -6614 48 9294 9296 -6615 48 9297 9298 -6616 48 9297 9299 -6617 48 9300 9301 -6618 48 9300 9302 -6619 48 9303 9304 -6620 48 9303 9305 -6621 48 9306 9307 -6622 48 9306 9308 -6623 48 9309 9310 -6624 48 9309 9311 -6625 48 9312 9313 -6626 48 9312 9314 -6627 48 9315 9316 -6628 48 9315 9317 -6629 48 9318 9319 -6630 48 9318 9320 -6631 48 9321 9322 -6632 48 9321 9323 -6633 48 9324 9325 -6634 48 9324 9326 -6635 48 9327 9328 -6636 48 9327 9329 -6637 48 9330 9331 -6638 48 9330 9332 -6639 48 9333 9334 -6640 48 9333 9335 -6641 48 9336 9337 -6642 48 9336 9338 -6643 48 9339 9340 -6644 48 9339 9341 -6645 48 9342 9343 -6646 48 9342 9344 -6647 48 9345 9346 -6648 48 9345 9347 -6649 48 9348 9349 -6650 48 9348 9350 -6651 48 9351 9352 -6652 48 9351 9353 -6653 48 9354 9355 -6654 48 9354 9356 -6655 48 9357 9358 -6656 48 9357 9359 -6657 48 9360 9361 -6658 48 9360 9362 -6659 48 9363 9364 -6660 48 9363 9365 -6661 48 9366 9367 -6662 48 9366 9368 -6663 48 9369 9370 -6664 48 9369 9371 -6665 48 9372 9373 -6666 48 9372 9374 -6667 48 9375 9376 -6668 48 9375 9377 -6669 48 9378 9379 -6670 48 9378 9380 -6671 48 9381 9382 -6672 48 9381 9383 -6673 48 9384 9385 -6674 48 9384 9386 -6675 48 9387 9388 -6676 48 9387 9389 -6677 48 9390 9391 -6678 48 9390 9392 -6679 48 9393 9394 -6680 48 9393 9395 -6681 48 9396 9397 -6682 48 9396 9398 -6683 48 9399 9400 -6684 48 9399 9401 -6685 48 9402 9403 -6686 48 9402 9404 -6687 48 9405 9406 -6688 48 9405 9407 -6689 48 9408 9409 -6690 48 9408 9410 -6691 48 9411 9412 -6692 48 9411 9413 -6693 48 9414 9415 -6694 48 9414 9416 -6695 48 9417 9418 -6696 48 9417 9419 -6697 48 9420 9421 -6698 48 9420 9422 -6699 48 9423 9424 -6700 48 9423 9425 -6701 48 9426 9427 -6702 48 9426 9428 -6703 48 9429 9430 -6704 48 9429 9431 -6705 48 9432 9433 -6706 48 9432 9434 -6707 48 9435 9436 -6708 48 9435 9437 -6709 48 9438 9439 -6710 48 9438 9440 -6711 48 9441 9442 -6712 48 9441 9443 -6713 48 9444 9445 -6714 48 9444 9446 -6715 48 9447 9448 -6716 48 9447 9449 -6717 48 9450 9451 -6718 48 9450 9452 -6719 48 9453 9454 -6720 48 9453 9455 -6721 48 9456 9457 -6722 48 9456 9458 -6723 48 9459 9460 -6724 48 9459 9461 -6725 48 9462 9463 -6726 48 9462 9464 -6727 48 9465 9466 -6728 48 9465 9467 -6729 48 9468 9469 -6730 48 9468 9470 -6731 48 9471 9472 -6732 48 9471 9473 -6733 48 9474 9475 -6734 48 9474 9476 -6735 48 9477 9478 -6736 48 9477 9479 -6737 48 9480 9481 -6738 48 9480 9482 -6739 48 9483 9484 -6740 48 9483 9485 -6741 48 9486 9487 -6742 48 9486 9488 -6743 48 9489 9490 -6744 48 9489 9491 -6745 48 9492 9493 -6746 48 9492 9494 -6747 48 9495 9496 -6748 48 9495 9497 -6749 48 9498 9499 -6750 48 9498 9500 -6751 48 9501 9502 -6752 48 9501 9503 -6753 48 9504 9505 -6754 48 9504 9506 -6755 48 9507 9508 -6756 48 9507 9509 -6757 48 9510 9511 -6758 48 9510 9512 -6759 48 9513 9514 -6760 48 9513 9515 -6761 48 9516 9517 -6762 48 9516 9518 -6763 48 9519 9520 -6764 48 9519 9521 -6765 48 9522 9523 -6766 48 9522 9524 -6767 48 9525 9526 -6768 48 9525 9527 -6769 48 9528 9529 -6770 48 9528 9530 -6771 48 9531 9532 -6772 48 9531 9533 -6773 48 9534 9535 -6774 48 9534 9536 -6775 48 9537 9538 -6776 48 9537 9539 -6777 48 9540 9541 -6778 48 9540 9542 -6779 48 9543 9544 -6780 48 9543 9545 -6781 48 9546 9547 -6782 48 9546 9548 -6783 48 9549 9550 -6784 48 9549 9551 -6785 48 9552 9553 -6786 48 9552 9554 -6787 48 9555 9556 -6788 48 9555 9557 -6789 48 9558 9559 -6790 48 9558 9560 -6791 48 9561 9562 -6792 48 9561 9563 -6793 48 9564 9565 -6794 48 9564 9566 -6795 48 9567 9568 -6796 48 9567 9569 -6797 48 9570 9571 -6798 48 9570 9572 -6799 48 9573 9574 -6800 48 9573 9575 -6801 48 9576 9577 -6802 48 9576 9578 -6803 48 9579 9580 -6804 48 9579 9581 -6805 48 9582 9583 -6806 48 9582 9584 -6807 48 9585 9586 -6808 48 9585 9587 -6809 48 9588 9589 -6810 48 9588 9590 -6811 48 9591 9592 -6812 48 9591 9593 -6813 48 9594 9595 -6814 48 9594 9596 -6815 48 9597 9598 -6816 48 9597 9599 -6817 48 9600 9601 -6818 48 9600 9602 -6819 48 9603 9604 -6820 48 9603 9605 -6821 48 9606 9607 -6822 48 9606 9608 -6823 48 9609 9610 -6824 48 9609 9611 -6825 48 9612 9613 -6826 48 9612 9614 -6827 48 9615 9616 -6828 48 9615 9617 -6829 48 9618 9619 -6830 48 9618 9620 -6831 48 9621 9622 -6832 48 9621 9623 -6833 48 9624 9625 -6834 48 9624 9626 -6835 48 9627 9628 -6836 48 9627 9629 -6837 48 9630 9631 -6838 48 9630 9632 -6839 48 9633 9634 -6840 48 9633 9635 -6841 48 9636 9637 -6842 48 9636 9638 -6843 48 9639 9640 -6844 48 9639 9641 -6845 48 9642 9643 -6846 48 9642 9644 -6847 48 9645 9646 -6848 48 9645 9647 -6849 48 9648 9649 -6850 48 9648 9650 -6851 48 9651 9652 -6852 48 9651 9653 -6853 48 9654 9655 -6854 48 9654 9656 -6855 48 9657 9658 -6856 48 9657 9659 -6857 48 9660 9661 -6858 48 9660 9662 -6859 48 9663 9664 -6860 48 9663 9665 -6861 48 9666 9667 -6862 48 9666 9668 -6863 48 9669 9670 -6864 48 9669 9671 -6865 48 9672 9673 -6866 48 9672 9674 -6867 48 9675 9676 -6868 48 9675 9677 -6869 48 9678 9679 -6870 48 9678 9680 -6871 48 9681 9682 -6872 48 9681 9683 -6873 48 9684 9685 -6874 48 9684 9686 -6875 48 9687 9688 -6876 48 9687 9689 -6877 48 9690 9691 -6878 48 9690 9692 -6879 48 9693 9694 -6880 48 9693 9695 -6881 48 9696 9697 -6882 48 9696 9698 -6883 48 9699 9700 -6884 48 9699 9701 -6885 48 9702 9703 -6886 48 9702 9704 -6887 48 9705 9706 -6888 48 9705 9707 -6889 48 9708 9709 -6890 48 9708 9710 -6891 48 9711 9712 -6892 48 9711 9713 -6893 48 9714 9715 -6894 48 9714 9716 -6895 48 9717 9718 -6896 48 9717 9719 -6897 48 9720 9721 -6898 48 9720 9722 -6899 48 9723 9724 -6900 48 9723 9725 -6901 48 9726 9727 -6902 48 9726 9728 -6903 48 9729 9730 -6904 48 9729 9731 -6905 48 9732 9733 -6906 48 9732 9734 -6907 48 9735 9736 -6908 48 9735 9737 -6909 49 1234 1235 -6910 49 1237 1238 -6911 49 1240 1241 -6912 49 1243 1244 -6913 49 1246 1247 -6914 49 1249 1250 -6915 49 1252 1253 -6916 49 1255 1256 -6917 49 1258 1259 -6918 49 1261 1262 -6919 49 1264 1265 -6920 49 1267 1268 -6921 49 1270 1271 -6922 49 1273 1274 -6923 49 1276 1277 -6924 49 1279 1280 -6925 49 1282 1283 -6926 49 1285 1286 -6927 49 1288 1289 -6928 49 1291 1292 -6929 49 1294 1295 -6930 49 1297 1298 -6931 49 1300 1301 -6932 49 1303 1304 -6933 49 1306 1307 -6934 49 1309 1310 -6935 49 1312 1313 -6936 49 1315 1316 -6937 49 1318 1319 -6938 49 1321 1322 -6939 49 1324 1325 -6940 49 1327 1328 -6941 49 1330 1331 -6942 49 1333 1334 -6943 49 1336 1337 -6944 49 1339 1340 -6945 49 1342 1343 -6946 49 1345 1346 -6947 49 1348 1349 -6948 49 1351 1352 -6949 49 1354 1355 -6950 49 1357 1358 -6951 49 1360 1361 -6952 49 1363 1364 -6953 49 1366 1367 -6954 49 1369 1370 -6955 49 1372 1373 -6956 49 1375 1376 -6957 49 1378 1379 -6958 49 1381 1382 -6959 49 1384 1385 -6960 49 1387 1388 -6961 49 1390 1391 -6962 49 1393 1394 -6963 49 1396 1397 -6964 49 1399 1400 -6965 49 1402 1403 -6966 49 1405 1406 -6967 49 1408 1409 -6968 49 1411 1412 -6969 49 1414 1415 -6970 49 1417 1418 -6971 49 1420 1421 -6972 49 1423 1424 -6973 49 1426 1427 -6974 49 1429 1430 -6975 49 1432 1433 -6976 49 1435 1436 -6977 49 1438 1439 -6978 49 1441 1442 -6979 49 1444 1445 -6980 49 1447 1448 -6981 49 1450 1451 -6982 49 1453 1454 -6983 49 1456 1457 -6984 49 1459 1460 -6985 49 1462 1463 -6986 49 1465 1466 -6987 49 1468 1469 -6988 49 1471 1472 -6989 49 1474 1475 -6990 49 1477 1478 -6991 49 1480 1481 -6992 49 1483 1484 -6993 49 1486 1487 -6994 49 1489 1490 -6995 49 1492 1493 -6996 49 1495 1496 -6997 49 1498 1499 -6998 49 1501 1502 -6999 49 1504 1505 -7000 49 1507 1508 -7001 49 1510 1511 -7002 49 1513 1514 -7003 49 1516 1517 -7004 49 1519 1520 -7005 49 1522 1523 -7006 49 1525 1526 -7007 49 1528 1529 -7008 49 1531 1532 -7009 49 1534 1535 -7010 49 1537 1538 -7011 49 1540 1541 -7012 49 1543 1544 -7013 49 1546 1547 -7014 49 1549 1550 -7015 49 1552 1553 -7016 49 1555 1556 -7017 49 1558 1559 -7018 49 1561 1562 -7019 49 1564 1565 -7020 49 1567 1568 -7021 49 1570 1571 -7022 49 1573 1574 -7023 49 1576 1577 -7024 49 1579 1580 -7025 49 1582 1583 -7026 49 1585 1586 -7027 49 1588 1589 -7028 49 1591 1592 -7029 49 1594 1595 -7030 49 1597 1598 -7031 49 1600 1601 -7032 49 1603 1604 -7033 49 1606 1607 -7034 49 1609 1610 -7035 49 1612 1613 -7036 49 1615 1616 -7037 49 1618 1619 -7038 49 1621 1622 -7039 49 1624 1625 -7040 49 1627 1628 -7041 49 1630 1631 -7042 49 1633 1634 -7043 49 1636 1637 -7044 49 1639 1640 -7045 49 1642 1643 -7046 49 1645 1646 -7047 49 1648 1649 -7048 49 1651 1652 -7049 49 1654 1655 -7050 49 1657 1658 -7051 49 1660 1661 -7052 49 1663 1664 -7053 49 1666 1667 -7054 49 1669 1670 -7055 49 1672 1673 -7056 49 1675 1676 -7057 49 1678 1679 -7058 49 1681 1682 -7059 49 1684 1685 -7060 49 1687 1688 -7061 49 1690 1691 -7062 49 1693 1694 -7063 49 1696 1697 -7064 49 1699 1700 -7065 49 1702 1703 -7066 49 1705 1706 -7067 49 1708 1709 -7068 49 1711 1712 -7069 49 1714 1715 -7070 49 1717 1718 -7071 49 1720 1721 -7072 49 1723 1724 -7073 49 1726 1727 -7074 49 1729 1730 -7075 49 1732 1733 -7076 49 1735 1736 -7077 49 1738 1739 -7078 49 1741 1742 -7079 49 1744 1745 -7080 49 1747 1748 -7081 49 1750 1751 -7082 49 1753 1754 -7083 49 1756 1757 -7084 49 1759 1760 -7085 49 1762 1763 -7086 49 1765 1766 -7087 49 1768 1769 -7088 49 1771 1772 -7089 49 1774 1775 -7090 49 1777 1778 -7091 49 1780 1781 -7092 49 1783 1784 -7093 49 1786 1787 -7094 49 1789 1790 -7095 49 1792 1793 -7096 49 1795 1796 -7097 49 1798 1799 -7098 49 1801 1802 -7099 49 1804 1805 -7100 49 1807 1808 -7101 49 1810 1811 -7102 49 1813 1814 -7103 49 1816 1817 -7104 49 1819 1820 -7105 49 1822 1823 -7106 49 1825 1826 -7107 49 1828 1829 -7108 49 1831 1832 -7109 49 1834 1835 -7110 49 1837 1838 -7111 49 1840 1841 -7112 49 1843 1844 -7113 49 1846 1847 -7114 49 1849 1850 -7115 49 1852 1853 -7116 49 1855 1856 -7117 49 1858 1859 -7118 49 1861 1862 -7119 49 1864 1865 -7120 49 1867 1868 -7121 49 1870 1871 -7122 49 1873 1874 -7123 49 1876 1877 -7124 49 1879 1880 -7125 49 1882 1883 -7126 49 1885 1886 -7127 49 1888 1889 -7128 49 1891 1892 -7129 49 1894 1895 -7130 49 1897 1898 -7131 49 1900 1901 -7132 49 1903 1904 -7133 49 1906 1907 -7134 49 1909 1910 -7135 49 1912 1913 -7136 49 1915 1916 -7137 49 1918 1919 -7138 49 1921 1922 -7139 49 1924 1925 -7140 49 1927 1928 -7141 49 1930 1931 -7142 49 1933 1934 -7143 49 1936 1937 -7144 49 1939 1940 -7145 49 1942 1943 -7146 49 1945 1946 -7147 49 1948 1949 -7148 49 1951 1952 -7149 49 1954 1955 -7150 49 1957 1958 -7151 49 1960 1961 -7152 49 1963 1964 -7153 49 1966 1967 -7154 49 1969 1970 -7155 49 1972 1973 -7156 49 1975 1976 -7157 49 1978 1979 -7158 49 1981 1982 -7159 49 1984 1985 -7160 49 1987 1988 -7161 49 1990 1991 -7162 49 1993 1994 -7163 49 1996 1997 -7164 49 1999 2000 -7165 49 2002 2003 -7166 49 2005 2006 -7167 49 2008 2009 -7168 49 2011 2012 -7169 49 2014 2015 -7170 49 2017 2018 -7171 49 2020 2021 -7172 49 2023 2024 -7173 49 2026 2027 -7174 49 2029 2030 -7175 49 2032 2033 -7176 49 2035 2036 -7177 49 2038 2039 -7178 49 2041 2042 -7179 49 2044 2045 -7180 49 2047 2048 -7181 49 2050 2051 -7182 49 2053 2054 -7183 49 2056 2057 -7184 49 2059 2060 -7185 49 2062 2063 -7186 49 2065 2066 -7187 49 2068 2069 -7188 49 2071 2072 -7189 49 2074 2075 -7190 49 2077 2078 -7191 49 2080 2081 -7192 49 2083 2084 -7193 49 2086 2087 -7194 49 2089 2090 -7195 49 2092 2093 -7196 49 2095 2096 -7197 49 2098 2099 -7198 49 2101 2102 -7199 49 2104 2105 -7200 49 2107 2108 -7201 49 2110 2111 -7202 49 2113 2114 -7203 49 2116 2117 -7204 49 2119 2120 -7205 49 2122 2123 -7206 49 2125 2126 -7207 49 2128 2129 -7208 49 2131 2132 -7209 49 2134 2135 -7210 49 2137 2138 -7211 49 2140 2141 -7212 49 2143 2144 -7213 49 2146 2147 -7214 49 2149 2150 -7215 49 2152 2153 -7216 49 2155 2156 -7217 49 2158 2159 -7218 49 2161 2162 -7219 49 2164 2165 -7220 49 2167 2168 -7221 49 2170 2171 -7222 49 2173 2174 -7223 49 2176 2177 -7224 49 2179 2180 -7225 49 2182 2183 -7226 49 2185 2186 -7227 49 2188 2189 -7228 49 2191 2192 -7229 49 2194 2195 -7230 49 2197 2198 -7231 49 2200 2201 -7232 49 2203 2204 -7233 49 2206 2207 -7234 49 2209 2210 -7235 49 2212 2213 -7236 49 2215 2216 -7237 49 2218 2219 -7238 49 2221 2222 -7239 49 2224 2225 -7240 49 2227 2228 -7241 49 2230 2231 -7242 49 2233 2234 -7243 49 2236 2237 -7244 49 2239 2240 -7245 49 2242 2243 -7246 49 2245 2246 -7247 49 2248 2249 -7248 49 2251 2252 -7249 49 2254 2255 -7250 49 2257 2258 -7251 49 2260 2261 -7252 49 2263 2264 -7253 49 2266 2267 -7254 49 2269 2270 -7255 49 2272 2273 -7256 49 2275 2276 -7257 49 2278 2279 -7258 49 2281 2282 -7259 49 2284 2285 -7260 49 2287 2288 -7261 49 2290 2291 -7262 49 2293 2294 -7263 49 2296 2297 -7264 49 2299 2300 -7265 49 2302 2303 -7266 49 2305 2306 -7267 49 2308 2309 -7268 49 2311 2312 -7269 49 2314 2315 -7270 49 2317 2318 -7271 49 2320 2321 -7272 49 2323 2324 -7273 49 2326 2327 -7274 49 2329 2330 -7275 49 2332 2333 -7276 49 2335 2336 -7277 49 2338 2339 -7278 49 2341 2342 -7279 49 2344 2345 -7280 49 2347 2348 -7281 49 2350 2351 -7282 49 2353 2354 -7283 49 2356 2357 -7284 49 2359 2360 -7285 49 2362 2363 -7286 49 2365 2366 -7287 49 2368 2369 -7288 49 2371 2372 -7289 49 2374 2375 -7290 49 2377 2378 -7291 49 2380 2381 -7292 49 2383 2384 -7293 49 2386 2387 -7294 49 2389 2390 -7295 49 2392 2393 -7296 49 2395 2396 -7297 49 2398 2399 -7298 49 2401 2402 -7299 49 2404 2405 -7300 49 2407 2408 -7301 49 2410 2411 -7302 49 2413 2414 -7303 49 2416 2417 -7304 49 2419 2420 -7305 49 2422 2423 -7306 49 2425 2426 -7307 49 2428 2429 -7308 49 2431 2432 -7309 49 2434 2435 -7310 49 2437 2438 -7311 49 2440 2441 -7312 49 2443 2444 -7313 49 2446 2447 -7314 49 2449 2450 -7315 49 2452 2453 -7316 49 2455 2456 -7317 49 2458 2459 -7318 49 2461 2462 -7319 49 2464 2465 -7320 49 2467 2468 -7321 49 2470 2471 -7322 49 2473 2474 -7323 49 2476 2477 -7324 49 2479 2480 -7325 49 2482 2483 -7326 49 2485 2486 -7327 49 2488 2489 -7328 49 2491 2492 -7329 49 2494 2495 -7330 49 2497 2498 -7331 49 2500 2501 -7332 49 2503 2504 -7333 49 2506 2507 -7334 49 2509 2510 -7335 49 2512 2513 -7336 49 2515 2516 -7337 49 2518 2519 -7338 49 2521 2522 -7339 49 2524 2525 -7340 49 2527 2528 -7341 49 2530 2531 -7342 49 2533 2534 -7343 49 2536 2537 -7344 49 2539 2540 -7345 49 2542 2543 -7346 49 2545 2546 -7347 49 2548 2549 -7348 49 2551 2552 -7349 49 2554 2555 -7350 49 2557 2558 -7351 49 2560 2561 -7352 49 2563 2564 -7353 49 2566 2567 -7354 49 2569 2570 -7355 49 2572 2573 -7356 49 2575 2576 -7357 49 2578 2579 -7358 49 2581 2582 -7359 49 2584 2585 -7360 49 2587 2588 -7361 49 2590 2591 -7362 49 2593 2594 -7363 49 2596 2597 -7364 49 2599 2600 -7365 49 2602 2603 -7366 49 2605 2606 -7367 49 2608 2609 -7368 49 2611 2612 -7369 49 2614 2615 -7370 49 2617 2618 -7371 49 2620 2621 -7372 49 2623 2624 -7373 49 2626 2627 -7374 49 2629 2630 -7375 49 2632 2633 -7376 49 2635 2636 -7377 49 2638 2639 -7378 49 2641 2642 -7379 49 2644 2645 -7380 49 2647 2648 -7381 49 2650 2651 -7382 49 2653 2654 -7383 49 2656 2657 -7384 49 2659 2660 -7385 49 2662 2663 -7386 49 2665 2666 -7387 49 2668 2669 -7388 49 2671 2672 -7389 49 2674 2675 -7390 49 2677 2678 -7391 49 2680 2681 -7392 49 2683 2684 -7393 49 2686 2687 -7394 49 2689 2690 -7395 49 2692 2693 -7396 49 2695 2696 -7397 49 2698 2699 -7398 49 2701 2702 -7399 49 2704 2705 -7400 49 2707 2708 -7401 49 2710 2711 -7402 49 2713 2714 -7403 49 2716 2717 -7404 49 2719 2720 -7405 49 2722 2723 -7406 49 2725 2726 -7407 49 2728 2729 -7408 49 2731 2732 -7409 49 2734 2735 -7410 49 2737 2738 -7411 49 2740 2741 -7412 49 2743 2744 -7413 49 2746 2747 -7414 49 2749 2750 -7415 49 2752 2753 -7416 49 2755 2756 -7417 49 2758 2759 -7418 49 2761 2762 -7419 49 2764 2765 -7420 49 2767 2768 -7421 49 2770 2771 -7422 49 2773 2774 -7423 49 2776 2777 -7424 49 2779 2780 -7425 49 2782 2783 -7426 49 2785 2786 -7427 49 2788 2789 -7428 49 2791 2792 -7429 49 2794 2795 -7430 49 2797 2798 -7431 49 2800 2801 -7432 49 2803 2804 -7433 49 2806 2807 -7434 49 2809 2810 -7435 49 2812 2813 -7436 49 2815 2816 -7437 49 2818 2819 -7438 49 2821 2822 -7439 49 2824 2825 -7440 49 2827 2828 -7441 49 2830 2831 -7442 49 2833 2834 -7443 49 2836 2837 -7444 49 2839 2840 -7445 49 2842 2843 -7446 49 2845 2846 -7447 49 2848 2849 -7448 49 2851 2852 -7449 49 2854 2855 -7450 49 2857 2858 -7451 49 2860 2861 -7452 49 2863 2864 -7453 49 2866 2867 -7454 49 2869 2870 -7455 49 2872 2873 -7456 49 2875 2876 -7457 49 2878 2879 -7458 49 2881 2882 -7459 49 2884 2885 -7460 49 2887 2888 -7461 49 2890 2891 -7462 49 2893 2894 -7463 49 2896 2897 -7464 49 2899 2900 -7465 49 2902 2903 -7466 49 2905 2906 -7467 49 2908 2909 -7468 49 2911 2912 -7469 49 2914 2915 -7470 49 2917 2918 -7471 49 2920 2921 -7472 49 2923 2924 -7473 49 2926 2927 -7474 49 2929 2930 -7475 49 2932 2933 -7476 49 2935 2936 -7477 49 2938 2939 -7478 49 2941 2942 -7479 49 2944 2945 -7480 49 2947 2948 -7481 49 2950 2951 -7482 49 2953 2954 -7483 49 2956 2957 -7484 49 2959 2960 -7485 49 2962 2963 -7486 49 2965 2966 -7487 49 2968 2969 -7488 49 2971 2972 -7489 49 2974 2975 -7490 49 2977 2978 -7491 49 2980 2981 -7492 49 2983 2984 -7493 49 2986 2987 -7494 49 2989 2990 -7495 49 2992 2993 -7496 49 2995 2996 -7497 49 2998 2999 -7498 49 3001 3002 -7499 49 3004 3005 -7500 49 3007 3008 -7501 49 3010 3011 -7502 49 3013 3014 -7503 49 3016 3017 -7504 49 3019 3020 -7505 49 3022 3023 -7506 49 3025 3026 -7507 49 3028 3029 -7508 49 3031 3032 -7509 49 3034 3035 -7510 49 3037 3038 -7511 49 3040 3041 -7512 49 3043 3044 -7513 49 3046 3047 -7514 49 3049 3050 -7515 49 3052 3053 -7516 49 3055 3056 -7517 49 3058 3059 -7518 49 3061 3062 -7519 49 3064 3065 -7520 49 3067 3068 -7521 49 3070 3071 -7522 49 3073 3074 -7523 49 3076 3077 -7524 49 3079 3080 -7525 49 3082 3083 -7526 49 3085 3086 -7527 49 3088 3089 -7528 49 3091 3092 -7529 49 3094 3095 -7530 49 3097 3098 -7531 49 3100 3101 -7532 49 3103 3104 -7533 49 3106 3107 -7534 49 3109 3110 -7535 49 3112 3113 -7536 49 3115 3116 -7537 49 3118 3119 -7538 49 3121 3122 -7539 49 3124 3125 -7540 49 3127 3128 -7541 49 3130 3131 -7542 49 3133 3134 -7543 49 3136 3137 -7544 49 3139 3140 -7545 49 3142 3143 -7546 49 3145 3146 -7547 49 3148 3149 -7548 49 3151 3152 -7549 49 3154 3155 -7550 49 3157 3158 -7551 49 3160 3161 -7552 49 3163 3164 -7553 49 3166 3167 -7554 49 3169 3170 -7555 49 3172 3173 -7556 49 3175 3176 -7557 49 3178 3179 -7558 49 3181 3182 -7559 49 3184 3185 -7560 49 3187 3188 -7561 49 3190 3191 -7562 49 3193 3194 -7563 49 3196 3197 -7564 49 3199 3200 -7565 49 3202 3203 -7566 49 3205 3206 -7567 49 3208 3209 -7568 49 3211 3212 -7569 49 3214 3215 -7570 49 3217 3218 -7571 49 3220 3221 -7572 49 3223 3224 -7573 49 3226 3227 -7574 49 3229 3230 -7575 49 3232 3233 -7576 49 3235 3236 -7577 49 3238 3239 -7578 49 3241 3242 -7579 49 3244 3245 -7580 49 3247 3248 -7581 49 3250 3251 -7582 49 3253 3254 -7583 49 3256 3257 -7584 49 3259 3260 -7585 49 3262 3263 -7586 49 3265 3266 -7587 49 3268 3269 -7588 49 3271 3272 -7589 49 3274 3275 -7590 49 3277 3278 -7591 49 3280 3281 -7592 49 3283 3284 -7593 49 3286 3287 -7594 49 3289 3290 -7595 49 3292 3293 -7596 49 3295 3296 -7597 49 3298 3299 -7598 49 3301 3302 -7599 49 3304 3305 -7600 49 3307 3308 -7601 49 3310 3311 -7602 49 3313 3314 -7603 49 3316 3317 -7604 49 3319 3320 -7605 49 3322 3323 -7606 49 3325 3326 -7607 49 3328 3329 -7608 49 3331 3332 -7609 49 3334 3335 -7610 49 3337 3338 -7611 49 3340 3341 -7612 49 3343 3344 -7613 49 3346 3347 -7614 49 3349 3350 -7615 49 3352 3353 -7616 49 3355 3356 -7617 49 3358 3359 -7618 49 3361 3362 -7619 49 3364 3365 -7620 49 3367 3368 -7621 49 3370 3371 -7622 49 3373 3374 -7623 49 3376 3377 -7624 49 3379 3380 -7625 49 3382 3383 -7626 49 3385 3386 -7627 49 3388 3389 -7628 49 3391 3392 -7629 49 3394 3395 -7630 49 3397 3398 -7631 49 3400 3401 -7632 49 3403 3404 -7633 49 3406 3407 -7634 49 3409 3410 -7635 49 3412 3413 -7636 49 3415 3416 -7637 49 3418 3419 -7638 49 3421 3422 -7639 49 3424 3425 -7640 49 3427 3428 -7641 49 3430 3431 -7642 49 3433 3434 -7643 49 3436 3437 -7644 49 3439 3440 -7645 49 3442 3443 -7646 49 3445 3446 -7647 49 3448 3449 -7648 49 3451 3452 -7649 49 3454 3455 -7650 49 3457 3458 -7651 49 3460 3461 -7652 49 3463 3464 -7653 49 3466 3467 -7654 49 3469 3470 -7655 49 3472 3473 -7656 49 3475 3476 -7657 49 3478 3479 -7658 49 3481 3482 -7659 49 3484 3485 -7660 49 3487 3488 -7661 49 3490 3491 -7662 49 3493 3494 -7663 49 3496 3497 -7664 49 3499 3500 -7665 49 3502 3503 -7666 49 3505 3506 -7667 49 3508 3509 -7668 49 3511 3512 -7669 49 3514 3515 -7670 49 3517 3518 -7671 49 3520 3521 -7672 49 3523 3524 -7673 49 3526 3527 -7674 49 3529 3530 -7675 49 3532 3533 -7676 49 3535 3536 -7677 49 3538 3539 -7678 49 3541 3542 -7679 49 3544 3545 -7680 49 3547 3548 -7681 49 3550 3551 -7682 49 3553 3554 -7683 49 3556 3557 -7684 49 3559 3560 -7685 49 3562 3563 -7686 49 3565 3566 -7687 49 3568 3569 -7688 49 3571 3572 -7689 49 3574 3575 -7690 49 3577 3578 -7691 49 3580 3581 -7692 49 3583 3584 -7693 49 3586 3587 -7694 49 3589 3590 -7695 49 3592 3593 -7696 49 3595 3596 -7697 49 3598 3599 -7698 49 3601 3602 -7699 49 3604 3605 -7700 49 3607 3608 -7701 49 3610 3611 -7702 49 3613 3614 -7703 49 3616 3617 -7704 49 3619 3620 -7705 49 3622 3623 -7706 49 3625 3626 -7707 49 3628 3629 -7708 49 3631 3632 -7709 49 3634 3635 -7710 49 3637 3638 -7711 49 3640 3641 -7712 49 3643 3644 -7713 49 3646 3647 -7714 49 3649 3650 -7715 49 3652 3653 -7716 49 3655 3656 -7717 49 3658 3659 -7718 49 3661 3662 -7719 49 3664 3665 -7720 49 3667 3668 -7721 49 3670 3671 -7722 49 3673 3674 -7723 49 3676 3677 -7724 49 3679 3680 -7725 49 3682 3683 -7726 49 3685 3686 -7727 49 3688 3689 -7728 49 3691 3692 -7729 49 3694 3695 -7730 49 3697 3698 -7731 49 3700 3701 -7732 49 3703 3704 -7733 49 3706 3707 -7734 49 3709 3710 -7735 49 3712 3713 -7736 49 3715 3716 -7737 49 3718 3719 -7738 49 3721 3722 -7739 49 3724 3725 -7740 49 3727 3728 -7741 49 3730 3731 -7742 49 3733 3734 -7743 49 3736 3737 -7744 49 3739 3740 -7745 49 3742 3743 -7746 49 3745 3746 -7747 49 3748 3749 -7748 49 3751 3752 -7749 49 3754 3755 -7750 49 3757 3758 -7751 49 3760 3761 -7752 49 3763 3764 -7753 49 3766 3767 -7754 49 3769 3770 -7755 49 3772 3773 -7756 49 3775 3776 -7757 49 3778 3779 -7758 49 3781 3782 -7759 49 3784 3785 -7760 49 3787 3788 -7761 49 3790 3791 -7762 49 3793 3794 -7763 49 3796 3797 -7764 49 3799 3800 -7765 49 3802 3803 -7766 49 3805 3806 -7767 49 3808 3809 -7768 49 3811 3812 -7769 49 3814 3815 -7770 49 3817 3818 -7771 49 3820 3821 -7772 49 3823 3824 -7773 49 3826 3827 -7774 49 3829 3830 -7775 49 3832 3833 -7776 49 3835 3836 -7777 49 3838 3839 -7778 49 3841 3842 -7779 49 3844 3845 -7780 49 3847 3848 -7781 49 3850 3851 -7782 49 3853 3854 -7783 49 3856 3857 -7784 49 3859 3860 -7785 49 3862 3863 -7786 49 3865 3866 -7787 49 3868 3869 -7788 49 3871 3872 -7789 49 3874 3875 -7790 49 3877 3878 -7791 49 3880 3881 -7792 49 3883 3884 -7793 49 3886 3887 -7794 49 3889 3890 -7795 49 3892 3893 -7796 49 3895 3896 -7797 49 3898 3899 -7798 49 3901 3902 -7799 49 3904 3905 -7800 49 3907 3908 -7801 49 3910 3911 -7802 49 3913 3914 -7803 49 3916 3917 -7804 49 3919 3920 -7805 49 3922 3923 -7806 49 3925 3926 -7807 49 3928 3929 -7808 49 3931 3932 -7809 49 3934 3935 -7810 49 3937 3938 -7811 49 3940 3941 -7812 49 3943 3944 -7813 49 3946 3947 -7814 49 3949 3950 -7815 49 3952 3953 -7816 49 3955 3956 -7817 49 3958 3959 -7818 49 3961 3962 -7819 49 3964 3965 -7820 49 3967 3968 -7821 49 3970 3971 -7822 49 3973 3974 -7823 49 3976 3977 -7824 49 3979 3980 -7825 49 3982 3983 -7826 49 3985 3986 -7827 49 3988 3989 -7828 49 3991 3992 -7829 49 3994 3995 -7830 49 3997 3998 -7831 49 4000 4001 -7832 49 4003 4004 -7833 49 4006 4007 -7834 49 4009 4010 -7835 49 4012 4013 -7836 49 4015 4016 -7837 49 4018 4019 -7838 49 4021 4022 -7839 49 4024 4025 -7840 49 4027 4028 -7841 49 4030 4031 -7842 49 4033 4034 -7843 49 4036 4037 -7844 49 4039 4040 -7845 49 4042 4043 -7846 49 4045 4046 -7847 49 4048 4049 -7848 49 4051 4052 -7849 49 4054 4055 -7850 49 4057 4058 -7851 49 4060 4061 -7852 49 4063 4064 -7853 49 4066 4067 -7854 49 4069 4070 -7855 49 4072 4073 -7856 49 4075 4076 -7857 49 4078 4079 -7858 49 4081 4082 -7859 49 4084 4085 -7860 49 4087 4088 -7861 49 4090 4091 -7862 49 4093 4094 -7863 49 4096 4097 -7864 49 4099 4100 -7865 49 4102 4103 -7866 49 4105 4106 -7867 49 4108 4109 -7868 49 4111 4112 -7869 49 4114 4115 -7870 49 4117 4118 -7871 49 4120 4121 -7872 49 4123 4124 -7873 49 4126 4127 -7874 49 4129 4130 -7875 49 4132 4133 -7876 49 4135 4136 -7877 49 4138 4139 -7878 49 4141 4142 -7879 49 4144 4145 -7880 49 4147 4148 -7881 49 4150 4151 -7882 49 4153 4154 -7883 49 4156 4157 -7884 49 4159 4160 -7885 49 4162 4163 -7886 49 4165 4166 -7887 49 4168 4169 -7888 49 4171 4172 -7889 49 4174 4175 -7890 49 4177 4178 -7891 49 4180 4181 -7892 49 4183 4184 -7893 49 4186 4187 -7894 49 4189 4190 -7895 49 4192 4193 -7896 49 4195 4196 -7897 49 4198 4199 -7898 49 4201 4202 -7899 49 4204 4205 -7900 49 4207 4208 -7901 49 4210 4211 -7902 49 4213 4214 -7903 49 4216 4217 -7904 49 4219 4220 -7905 49 4222 4223 -7906 49 4225 4226 -7907 49 4228 4229 -7908 49 4231 4232 -7909 49 4234 4235 -7910 49 4237 4238 -7911 49 4240 4241 -7912 49 4243 4244 -7913 49 4246 4247 -7914 49 4249 4250 -7915 49 4252 4253 -7916 49 4255 4256 -7917 49 4258 4259 -7918 49 4261 4262 -7919 49 4264 4265 -7920 49 4267 4268 -7921 49 4270 4271 -7922 49 4273 4274 -7923 49 4276 4277 -7924 49 4279 4280 -7925 49 4282 4283 -7926 49 4285 4286 -7927 49 4288 4289 -7928 49 4291 4292 -7929 49 4294 4295 -7930 49 4297 4298 -7931 49 4300 4301 -7932 49 4303 4304 -7933 49 4306 4307 -7934 49 4309 4310 -7935 49 4312 4313 -7936 49 4315 4316 -7937 49 4318 4319 -7938 49 4321 4322 -7939 49 4324 4325 -7940 49 4327 4328 -7941 49 4330 4331 -7942 49 4333 4334 -7943 49 4336 4337 -7944 49 4339 4340 -7945 49 4342 4343 -7946 49 4345 4346 -7947 49 4348 4349 -7948 49 4351 4352 -7949 49 4354 4355 -7950 49 4357 4358 -7951 49 4360 4361 -7952 49 4363 4364 -7953 49 4366 4367 -7954 49 4369 4370 -7955 49 4372 4373 -7956 49 4375 4376 -7957 49 4378 4379 -7958 49 4381 4382 -7959 49 4384 4385 -7960 49 4387 4388 -7961 49 4390 4391 -7962 49 4393 4394 -7963 49 4396 4397 -7964 49 4399 4400 -7965 49 4402 4403 -7966 49 4405 4406 -7967 49 4408 4409 -7968 49 4411 4412 -7969 49 4414 4415 -7970 49 4417 4418 -7971 49 4420 4421 -7972 49 4423 4424 -7973 49 4426 4427 -7974 49 4429 4430 -7975 49 4432 4433 -7976 49 4435 4436 -7977 49 4438 4439 -7978 49 4441 4442 -7979 49 4444 4445 -7980 49 4447 4448 -7981 49 4450 4451 -7982 49 4453 4454 -7983 49 4456 4457 -7984 49 4459 4460 -7985 49 4462 4463 -7986 49 4465 4466 -7987 49 4468 4469 -7988 49 4471 4472 -7989 49 4474 4475 -7990 49 4477 4478 -7991 49 4480 4481 -7992 49 4483 4484 -7993 49 4486 4487 -7994 49 4489 4490 -7995 49 4492 4493 -7996 49 4495 4496 -7997 49 4498 4499 -7998 49 4501 4502 -7999 49 4504 4505 -8000 49 4507 4508 -8001 49 4510 4511 -8002 49 4513 4514 -8003 49 4516 4517 -8004 49 4519 4520 -8005 49 4522 4523 -8006 49 4525 4526 -8007 49 4528 4529 -8008 49 4531 4532 -8009 49 4534 4535 -8010 49 4537 4538 -8011 49 4540 4541 -8012 49 4543 4544 -8013 49 4546 4547 -8014 49 4549 4550 -8015 49 4552 4553 -8016 49 4555 4556 -8017 49 4558 4559 -8018 49 4561 4562 -8019 49 4564 4565 -8020 49 4567 4568 -8021 49 4570 4571 -8022 49 4573 4574 -8023 49 4576 4577 -8024 49 4579 4580 -8025 49 4582 4583 -8026 49 4585 4586 -8027 49 4588 4589 -8028 49 4591 4592 -8029 49 4594 4595 -8030 49 4597 4598 -8031 49 4600 4601 -8032 49 4603 4604 -8033 49 4606 4607 -8034 49 4609 4610 -8035 49 4612 4613 -8036 49 4615 4616 -8037 49 4618 4619 -8038 49 4621 4622 -8039 49 4624 4625 -8040 49 4627 4628 -8041 49 4630 4631 -8042 49 4633 4634 -8043 49 4636 4637 -8044 49 4639 4640 -8045 49 4642 4643 -8046 49 4645 4646 -8047 49 4648 4649 -8048 49 4651 4652 -8049 49 4654 4655 -8050 49 4657 4658 -8051 49 4660 4661 -8052 49 4663 4664 -8053 49 4666 4667 -8054 49 4669 4670 -8055 49 4672 4673 -8056 49 4675 4676 -8057 49 4678 4679 -8058 49 4681 4682 -8059 49 4684 4685 -8060 49 4687 4688 -8061 49 4690 4691 -8062 49 4693 4694 -8063 49 4696 4697 -8064 49 4699 4700 -8065 49 4702 4703 -8066 49 4705 4706 -8067 49 4708 4709 -8068 49 4711 4712 -8069 49 4714 4715 -8070 49 4717 4718 -8071 49 4720 4721 -8072 49 4723 4724 -8073 49 4726 4727 -8074 49 4729 4730 -8075 49 4732 4733 -8076 49 4735 4736 -8077 49 4738 4739 -8078 49 4741 4742 -8079 49 4744 4745 -8080 49 4747 4748 -8081 49 4750 4751 -8082 49 4753 4754 -8083 49 4756 4757 -8084 49 4759 4760 -8085 49 4762 4763 -8086 49 4765 4766 -8087 49 4768 4769 -8088 49 4771 4772 -8089 49 4774 4775 -8090 49 4777 4778 -8091 49 4780 4781 -8092 49 4783 4784 -8093 49 4786 4787 -8094 49 4789 4790 -8095 49 4792 4793 -8096 49 4795 4796 -8097 49 4798 4799 -8098 49 4801 4802 -8099 49 4804 4805 -8100 49 4807 4808 -8101 49 4810 4811 -8102 49 4813 4814 -8103 49 4816 4817 -8104 49 4819 4820 -8105 49 4822 4823 -8106 49 4825 4826 -8107 49 4828 4829 -8108 49 4831 4832 -8109 49 4834 4835 -8110 49 4837 4838 -8111 49 4840 4841 -8112 49 4843 4844 -8113 49 4846 4847 -8114 49 4849 4850 -8115 49 4852 4853 -8116 49 4855 4856 -8117 49 4858 4859 -8118 49 4861 4862 -8119 49 4864 4865 -8120 49 4867 4868 -8121 49 4870 4871 -8122 49 4873 4874 -8123 49 4876 4877 -8124 49 4879 4880 -8125 49 4882 4883 -8126 49 4885 4886 -8127 49 4888 4889 -8128 49 4891 4892 -8129 49 4894 4895 -8130 49 4897 4898 -8131 49 4900 4901 -8132 49 4903 4904 -8133 49 4906 4907 -8134 49 4909 4910 -8135 49 4912 4913 -8136 49 4915 4916 -8137 49 4918 4919 -8138 49 4921 4922 -8139 49 4924 4925 -8140 49 4927 4928 -8141 49 4930 4931 -8142 49 4933 4934 -8143 49 4936 4937 -8144 49 4939 4940 -8145 49 4942 4943 -8146 49 4945 4946 -8147 49 4948 4949 -8148 49 4951 4952 -8149 49 4954 4955 -8150 49 4957 4958 -8151 49 4960 4961 -8152 49 4963 4964 -8153 49 4966 4967 -8154 49 4969 4970 -8155 49 4972 4973 -8156 49 4975 4976 -8157 49 4978 4979 -8158 49 4981 4982 -8159 49 4984 4985 -8160 49 4987 4988 -8161 49 4990 4991 -8162 49 4993 4994 -8163 49 4996 4997 -8164 49 4999 5000 -8165 49 5002 5003 -8166 49 5005 5006 -8167 49 5008 5009 -8168 49 5011 5012 -8169 49 5014 5015 -8170 49 5017 5018 -8171 49 5020 5021 -8172 49 5023 5024 -8173 49 5026 5027 -8174 49 5029 5030 -8175 49 5032 5033 -8176 49 5035 5036 -8177 49 5038 5039 -8178 49 5041 5042 -8179 49 5044 5045 -8180 49 5047 5048 -8181 49 5050 5051 -8182 49 5053 5054 -8183 49 5056 5057 -8184 49 5059 5060 -8185 49 5062 5063 -8186 49 5065 5066 -8187 49 5068 5069 -8188 49 5071 5072 -8189 49 5074 5075 -8190 49 5077 5078 -8191 49 5080 5081 -8192 49 5083 5084 -8193 49 5086 5087 -8194 49 5089 5090 -8195 49 5092 5093 -8196 49 5095 5096 -8197 49 5098 5099 -8198 49 5101 5102 -8199 49 5104 5105 -8200 49 5107 5108 -8201 49 5110 5111 -8202 49 5113 5114 -8203 49 5116 5117 -8204 49 5119 5120 -8205 49 5122 5123 -8206 49 5125 5126 -8207 49 5128 5129 -8208 49 5131 5132 -8209 49 5134 5135 -8210 49 5137 5138 -8211 49 5140 5141 -8212 49 5143 5144 -8213 49 5146 5147 -8214 49 5149 5150 -8215 49 5152 5153 -8216 49 5155 5156 -8217 49 5158 5159 -8218 49 5161 5162 -8219 49 5164 5165 -8220 49 5167 5168 -8221 49 5170 5171 -8222 49 5173 5174 -8223 49 5176 5177 -8224 49 5179 5180 -8225 49 5182 5183 -8226 49 5185 5186 -8227 49 5188 5189 -8228 49 5191 5192 -8229 49 5194 5195 -8230 49 5197 5198 -8231 49 5200 5201 -8232 49 5203 5204 -8233 49 5206 5207 -8234 49 5209 5210 -8235 49 5212 5213 -8236 49 5215 5216 -8237 49 5218 5219 -8238 49 5221 5222 -8239 49 5224 5225 -8240 49 5227 5228 -8241 49 5230 5231 -8242 49 5233 5234 -8243 49 5236 5237 -8244 49 5239 5240 -8245 49 5242 5243 -8246 49 5245 5246 -8247 49 5248 5249 -8248 49 5251 5252 -8249 49 5254 5255 -8250 49 5257 5258 -8251 49 5260 5261 -8252 49 5263 5264 -8253 49 5266 5267 -8254 49 5269 5270 -8255 49 5272 5273 -8256 49 5275 5276 -8257 49 5278 5279 -8258 49 5281 5282 -8259 49 5284 5285 -8260 49 5287 5288 -8261 49 5290 5291 -8262 49 5293 5294 -8263 49 5296 5297 -8264 49 5299 5300 -8265 49 5302 5303 -8266 49 5305 5306 -8267 49 5308 5309 -8268 49 5311 5312 -8269 49 5314 5315 -8270 49 5317 5318 -8271 49 5320 5321 -8272 49 5323 5324 -8273 49 5326 5327 -8274 49 5329 5330 -8275 49 5332 5333 -8276 49 5335 5336 -8277 49 5338 5339 -8278 49 5341 5342 -8279 49 5344 5345 -8280 49 5347 5348 -8281 49 5350 5351 -8282 49 5353 5354 -8283 49 5356 5357 -8284 49 5359 5360 -8285 49 5362 5363 -8286 49 5365 5366 -8287 49 5368 5369 -8288 49 5371 5372 -8289 49 5374 5375 -8290 49 5377 5378 -8291 49 5380 5381 -8292 49 5383 5384 -8293 49 5386 5387 -8294 49 5389 5390 -8295 49 5392 5393 -8296 49 5395 5396 -8297 49 5398 5399 -8298 49 5401 5402 -8299 49 5404 5405 -8300 49 5407 5408 -8301 49 5410 5411 -8302 49 5413 5414 -8303 49 5416 5417 -8304 49 5419 5420 -8305 49 5422 5423 -8306 49 5425 5426 -8307 49 5428 5429 -8308 49 5431 5432 -8309 49 5434 5435 -8310 49 5437 5438 -8311 49 5440 5441 -8312 49 5443 5444 -8313 49 5446 5447 -8314 49 5449 5450 -8315 49 5452 5453 -8316 49 5455 5456 -8317 49 5458 5459 -8318 49 5461 5462 -8319 49 5464 5465 -8320 49 5467 5468 -8321 49 5470 5471 -8322 49 5473 5474 -8323 49 5476 5477 -8324 49 5479 5480 -8325 49 5482 5483 -8326 49 5485 5486 -8327 49 5488 5489 -8328 49 5491 5492 -8329 49 5494 5495 -8330 49 5497 5498 -8331 49 5500 5501 -8332 49 5503 5504 -8333 49 5506 5507 -8334 49 5509 5510 -8335 49 5512 5513 -8336 49 5515 5516 -8337 49 5518 5519 -8338 49 5521 5522 -8339 49 5524 5525 -8340 49 5527 5528 -8341 49 5530 5531 -8342 49 5533 5534 -8343 49 5536 5537 -8344 49 5539 5540 -8345 49 5542 5543 -8346 49 5545 5546 -8347 49 5548 5549 -8348 49 5551 5552 -8349 49 5554 5555 -8350 49 5557 5558 -8351 49 5560 5561 -8352 49 5563 5564 -8353 49 5566 5567 -8354 49 5569 5570 -8355 49 5572 5573 -8356 49 5575 5576 -8357 49 5578 5579 -8358 49 5581 5582 -8359 49 5584 5585 -8360 49 5587 5588 -8361 49 5590 5591 -8362 49 5593 5594 -8363 49 5596 5597 -8364 49 5599 5600 -8365 49 5602 5603 -8366 49 5605 5606 -8367 49 5608 5609 -8368 49 5611 5612 -8369 49 5614 5615 -8370 49 5617 5618 -8371 49 5620 5621 -8372 49 5623 5624 -8373 49 5626 5627 -8374 49 5629 5630 -8375 49 5632 5633 -8376 49 5635 5636 -8377 49 5638 5639 -8378 49 5641 5642 -8379 49 5644 5645 -8380 49 5647 5648 -8381 49 5650 5651 -8382 49 5653 5654 -8383 49 5656 5657 -8384 49 5659 5660 -8385 49 5662 5663 -8386 49 5665 5666 -8387 49 5668 5669 -8388 49 5671 5672 -8389 49 5674 5675 -8390 49 5677 5678 -8391 49 5680 5681 -8392 49 5683 5684 -8393 49 5686 5687 -8394 49 5689 5690 -8395 49 5692 5693 -8396 49 5695 5696 -8397 49 5698 5699 -8398 49 5701 5702 -8399 49 5704 5705 -8400 49 5707 5708 -8401 49 5710 5711 -8402 49 5713 5714 -8403 49 5716 5717 -8404 49 5719 5720 -8405 49 5722 5723 -8406 49 5725 5726 -8407 49 5728 5729 -8408 49 5731 5732 -8409 49 5734 5735 -8410 49 5737 5738 -8411 49 5740 5741 -8412 49 5743 5744 -8413 49 5746 5747 -8414 49 5749 5750 -8415 49 5752 5753 -8416 49 5755 5756 -8417 49 5758 5759 -8418 49 5761 5762 -8419 49 5764 5765 -8420 49 5767 5768 -8421 49 5770 5771 -8422 49 5773 5774 -8423 49 5776 5777 -8424 49 5779 5780 -8425 49 5782 5783 -8426 49 5785 5786 -8427 49 5788 5789 -8428 49 5791 5792 -8429 49 5794 5795 -8430 49 5797 5798 -8431 49 5800 5801 -8432 49 5803 5804 -8433 49 5806 5807 -8434 49 5809 5810 -8435 49 5812 5813 -8436 49 5815 5816 -8437 49 5818 5819 -8438 49 5821 5822 -8439 49 5824 5825 -8440 49 5827 5828 -8441 49 5830 5831 -8442 49 5833 5834 -8443 49 5836 5837 -8444 49 5839 5840 -8445 49 5842 5843 -8446 49 5845 5846 -8447 49 5848 5849 -8448 49 5851 5852 -8449 49 5854 5855 -8450 49 5857 5858 -8451 49 5860 5861 -8452 49 5863 5864 -8453 49 5866 5867 -8454 49 5869 5870 -8455 49 5872 5873 -8456 49 5875 5876 -8457 49 5878 5879 -8458 49 5881 5882 -8459 49 5884 5885 -8460 49 5887 5888 -8461 49 5890 5891 -8462 49 5893 5894 -8463 49 5896 5897 -8464 49 5899 5900 -8465 49 5902 5903 -8466 49 5905 5906 -8467 49 5908 5909 -8468 49 5911 5912 -8469 49 5914 5915 -8470 49 5917 5918 -8471 49 5920 5921 -8472 49 5923 5924 -8473 49 5926 5927 -8474 49 5929 5930 -8475 49 5932 5933 -8476 49 5935 5936 -8477 49 5938 5939 -8478 49 5941 5942 -8479 49 5944 5945 -8480 49 5947 5948 -8481 49 5950 5951 -8482 49 5953 5954 -8483 49 5956 5957 -8484 49 5959 5960 -8485 49 5962 5963 -8486 49 5965 5966 -8487 49 5968 5969 -8488 49 5971 5972 -8489 49 5974 5975 -8490 49 5977 5978 -8491 49 5980 5981 -8492 49 5983 5984 -8493 49 5986 5987 -8494 49 5989 5990 -8495 49 5992 5993 -8496 49 5995 5996 -8497 49 5998 5999 -8498 49 6001 6002 -8499 49 6004 6005 -8500 49 6007 6008 -8501 49 6010 6011 -8502 49 6013 6014 -8503 49 6016 6017 -8504 49 6019 6020 -8505 49 6022 6023 -8506 49 6025 6026 -8507 49 6028 6029 -8508 49 6031 6032 -8509 49 6034 6035 -8510 49 6037 6038 -8511 49 6040 6041 -8512 49 6043 6044 -8513 49 6046 6047 -8514 49 6049 6050 -8515 49 6052 6053 -8516 49 6055 6056 -8517 49 6058 6059 -8518 49 6061 6062 -8519 49 6064 6065 -8520 49 6067 6068 -8521 49 6070 6071 -8522 49 6073 6074 -8523 49 6076 6077 -8524 49 6079 6080 -8525 49 6082 6083 -8526 49 6085 6086 -8527 49 6088 6089 -8528 49 6091 6092 -8529 49 6094 6095 -8530 49 6097 6098 -8531 49 6100 6101 -8532 49 6103 6104 -8533 49 6106 6107 -8534 49 6109 6110 -8535 49 6112 6113 -8536 49 6115 6116 -8537 49 6118 6119 -8538 49 6121 6122 -8539 49 6124 6125 -8540 49 6127 6128 -8541 49 6130 6131 -8542 49 6133 6134 -8543 49 6136 6137 -8544 49 6139 6140 -8545 49 6142 6143 -8546 49 6145 6146 -8547 49 6148 6149 -8548 49 6151 6152 -8549 49 6154 6155 -8550 49 6157 6158 -8551 49 6160 6161 -8552 49 6163 6164 -8553 49 6166 6167 -8554 49 6169 6170 -8555 49 6172 6173 -8556 49 6175 6176 -8557 49 6178 6179 -8558 49 6181 6182 -8559 49 6184 6185 -8560 49 6187 6188 -8561 49 6190 6191 -8562 49 6193 6194 -8563 49 6196 6197 -8564 49 6199 6200 -8565 49 6202 6203 -8566 49 6205 6206 -8567 49 6208 6209 -8568 49 6211 6212 -8569 49 6214 6215 -8570 49 6217 6218 -8571 49 6220 6221 -8572 49 6223 6224 -8573 49 6226 6227 -8574 49 6229 6230 -8575 49 6232 6233 -8576 49 6235 6236 -8577 49 6238 6239 -8578 49 6241 6242 -8579 49 6244 6245 -8580 49 6247 6248 -8581 49 6250 6251 -8582 49 6253 6254 -8583 49 6256 6257 -8584 49 6259 6260 -8585 49 6262 6263 -8586 49 6265 6266 -8587 49 6268 6269 -8588 49 6271 6272 -8589 49 6274 6275 -8590 49 6277 6278 -8591 49 6280 6281 -8592 49 6283 6284 -8593 49 6286 6287 -8594 49 6289 6290 -8595 49 6292 6293 -8596 49 6295 6296 -8597 49 6298 6299 -8598 49 6301 6302 -8599 49 6304 6305 -8600 49 6307 6308 -8601 49 6310 6311 -8602 49 6313 6314 -8603 49 6316 6317 -8604 49 6319 6320 -8605 49 6322 6323 -8606 49 6325 6326 -8607 49 6328 6329 -8608 49 6331 6332 -8609 49 6334 6335 -8610 49 6337 6338 -8611 49 6340 6341 -8612 49 6343 6344 -8613 49 6346 6347 -8614 49 6349 6350 -8615 49 6352 6353 -8616 49 6355 6356 -8617 49 6358 6359 -8618 49 6361 6362 -8619 49 6364 6365 -8620 49 6367 6368 -8621 49 6370 6371 -8622 49 6373 6374 -8623 49 6376 6377 -8624 49 6379 6380 -8625 49 6382 6383 -8626 49 6385 6386 -8627 49 6388 6389 -8628 49 6391 6392 -8629 49 6394 6395 -8630 49 6397 6398 -8631 49 6400 6401 -8632 49 6403 6404 -8633 49 6406 6407 -8634 49 6409 6410 -8635 49 6412 6413 -8636 49 6415 6416 -8637 49 6418 6419 -8638 49 6421 6422 -8639 49 6424 6425 -8640 49 6427 6428 -8641 49 6430 6431 -8642 49 6433 6434 -8643 49 6436 6437 -8644 49 6439 6440 -8645 49 6442 6443 -8646 49 6445 6446 -8647 49 6448 6449 -8648 49 6451 6452 -8649 49 6454 6455 -8650 49 6457 6458 -8651 49 6460 6461 -8652 49 6463 6464 -8653 49 6466 6467 -8654 49 6469 6470 -8655 49 6472 6473 -8656 49 6475 6476 -8657 49 6478 6479 -8658 49 6481 6482 -8659 49 6484 6485 -8660 49 6487 6488 -8661 49 6490 6491 -8662 49 6493 6494 -8663 49 6496 6497 -8664 49 6499 6500 -8665 49 6502 6503 -8666 49 6505 6506 -8667 49 6508 6509 -8668 49 6511 6512 -8669 49 6514 6515 -8670 49 6517 6518 -8671 49 6520 6521 -8672 49 6523 6524 -8673 49 6526 6527 -8674 49 6529 6530 -8675 49 6532 6533 -8676 49 6535 6536 -8677 49 6538 6539 -8678 49 6541 6542 -8679 49 6544 6545 -8680 49 6547 6548 -8681 49 6550 6551 -8682 49 6553 6554 -8683 49 6556 6557 -8684 49 6559 6560 -8685 49 6562 6563 -8686 49 6565 6566 -8687 49 6568 6569 -8688 49 6571 6572 -8689 49 6574 6575 -8690 49 6577 6578 -8691 49 6580 6581 -8692 49 6583 6584 -8693 49 6586 6587 -8694 49 6589 6590 -8695 49 6592 6593 -8696 49 6595 6596 -8697 49 6598 6599 -8698 49 6601 6602 -8699 49 6604 6605 -8700 49 6607 6608 -8701 49 6610 6611 -8702 49 6613 6614 -8703 49 6616 6617 -8704 49 6619 6620 -8705 49 6622 6623 -8706 49 6625 6626 -8707 49 6628 6629 -8708 49 6631 6632 -8709 49 6634 6635 -8710 49 6637 6638 -8711 49 6640 6641 -8712 49 6643 6644 -8713 49 6646 6647 -8714 49 6649 6650 -8715 49 6652 6653 -8716 49 6655 6656 -8717 49 6658 6659 -8718 49 6661 6662 -8719 49 6664 6665 -8720 49 6667 6668 -8721 49 6670 6671 -8722 49 6673 6674 -8723 49 6676 6677 -8724 49 6679 6680 -8725 49 6682 6683 -8726 49 6685 6686 -8727 49 6688 6689 -8728 49 6691 6692 -8729 49 6694 6695 -8730 49 6697 6698 -8731 49 6700 6701 -8732 49 6703 6704 -8733 49 6706 6707 -8734 49 6709 6710 -8735 49 6712 6713 -8736 49 6715 6716 -8737 49 6718 6719 -8738 49 6721 6722 -8739 49 6724 6725 -8740 49 6727 6728 -8741 49 6730 6731 -8742 49 6733 6734 -8743 49 6736 6737 -8744 49 6739 6740 -8745 49 6742 6743 -8746 49 6745 6746 -8747 49 6748 6749 -8748 49 6751 6752 -8749 49 6754 6755 -8750 49 6757 6758 -8751 49 6760 6761 -8752 49 6763 6764 -8753 49 6766 6767 -8754 49 6769 6770 -8755 49 6772 6773 -8756 49 6775 6776 -8757 49 6778 6779 -8758 49 6781 6782 -8759 49 6784 6785 -8760 49 6787 6788 -8761 49 6790 6791 -8762 49 6793 6794 -8763 49 6796 6797 -8764 49 6799 6800 -8765 49 6802 6803 -8766 49 6805 6806 -8767 49 6808 6809 -8768 49 6811 6812 -8769 49 6814 6815 -8770 49 6817 6818 -8771 49 6820 6821 -8772 49 6823 6824 -8773 49 6826 6827 -8774 49 6829 6830 -8775 49 6832 6833 -8776 49 6835 6836 -8777 49 6838 6839 -8778 49 6841 6842 -8779 49 6844 6845 -8780 49 6847 6848 -8781 49 6850 6851 -8782 49 6853 6854 -8783 49 6856 6857 -8784 49 6859 6860 -8785 49 6862 6863 -8786 49 6865 6866 -8787 49 6868 6869 -8788 49 6871 6872 -8789 49 6874 6875 -8790 49 6877 6878 -8791 49 6880 6881 -8792 49 6883 6884 -8793 49 6886 6887 -8794 49 6889 6890 -8795 49 6892 6893 -8796 49 6895 6896 -8797 49 6898 6899 -8798 49 6901 6902 -8799 49 6904 6905 -8800 49 6907 6908 -8801 49 6910 6911 -8802 49 6913 6914 -8803 49 6916 6917 -8804 49 6919 6920 -8805 49 6922 6923 -8806 49 6925 6926 -8807 49 6928 6929 -8808 49 6931 6932 -8809 49 6934 6935 -8810 49 6937 6938 -8811 49 6940 6941 -8812 49 6943 6944 -8813 49 6946 6947 -8814 49 6949 6950 -8815 49 6952 6953 -8816 49 6955 6956 -8817 49 6958 6959 -8818 49 6961 6962 -8819 49 6964 6965 -8820 49 6967 6968 -8821 49 6970 6971 -8822 49 6973 6974 -8823 49 6976 6977 -8824 49 6979 6980 -8825 49 6982 6983 -8826 49 6985 6986 -8827 49 6988 6989 -8828 49 6991 6992 -8829 49 6994 6995 -8830 49 6997 6998 -8831 49 7000 7001 -8832 49 7003 7004 -8833 49 7006 7007 -8834 49 7009 7010 -8835 49 7012 7013 -8836 49 7015 7016 -8837 49 7018 7019 -8838 49 7021 7022 -8839 49 7024 7025 -8840 49 7027 7028 -8841 49 7030 7031 -8842 49 7033 7034 -8843 49 7036 7037 -8844 49 7039 7040 -8845 49 7042 7043 -8846 49 7045 7046 -8847 49 7048 7049 -8848 49 7051 7052 -8849 49 7054 7055 -8850 49 7057 7058 -8851 49 7060 7061 -8852 49 7063 7064 -8853 49 7066 7067 -8854 49 7069 7070 -8855 49 7072 7073 -8856 49 7075 7076 -8857 49 7078 7079 -8858 49 7081 7082 -8859 49 7084 7085 -8860 49 7087 7088 -8861 49 7090 7091 -8862 49 7093 7094 -8863 49 7096 7097 -8864 49 7099 7100 -8865 49 7102 7103 -8866 49 7105 7106 -8867 49 7108 7109 -8868 49 7111 7112 -8869 49 7114 7115 -8870 49 7117 7118 -8871 49 7120 7121 -8872 49 7123 7124 -8873 49 7126 7127 -8874 49 7129 7130 -8875 49 7132 7133 -8876 49 7135 7136 -8877 49 7138 7139 -8878 49 7141 7142 -8879 49 7144 7145 -8880 49 7147 7148 -8881 49 7150 7151 -8882 49 7153 7154 -8883 49 7156 7157 -8884 49 7159 7160 -8885 49 7162 7163 -8886 49 7165 7166 -8887 49 7168 7169 -8888 49 7171 7172 -8889 49 7174 7175 -8890 49 7177 7178 -8891 49 7180 7181 -8892 49 7183 7184 -8893 49 7186 7187 -8894 49 7189 7190 -8895 49 7192 7193 -8896 49 7195 7196 -8897 49 7198 7199 -8898 49 7201 7202 -8899 49 7204 7205 -8900 49 7207 7208 -8901 49 7210 7211 -8902 49 7213 7214 -8903 49 7216 7217 -8904 49 7219 7220 -8905 49 7222 7223 -8906 49 7225 7226 -8907 49 7228 7229 -8908 49 7231 7232 -8909 49 7234 7235 -8910 49 7237 7238 -8911 49 7240 7241 -8912 49 7243 7244 -8913 49 7246 7247 -8914 49 7249 7250 -8915 49 7252 7253 -8916 49 7255 7256 -8917 49 7258 7259 -8918 49 7261 7262 -8919 49 7264 7265 -8920 49 7267 7268 -8921 49 7270 7271 -8922 49 7273 7274 -8923 49 7276 7277 -8924 49 7279 7280 -8925 49 7282 7283 -8926 49 7285 7286 -8927 49 7288 7289 -8928 49 7291 7292 -8929 49 7294 7295 -8930 49 7297 7298 -8931 49 7300 7301 -8932 49 7303 7304 -8933 49 7306 7307 -8934 49 7309 7310 -8935 49 7312 7313 -8936 49 7315 7316 -8937 49 7318 7319 -8938 49 7321 7322 -8939 49 7324 7325 -8940 49 7327 7328 -8941 49 7330 7331 -8942 49 7333 7334 -8943 49 7336 7337 -8944 49 7339 7340 -8945 49 7342 7343 -8946 49 7345 7346 -8947 49 7348 7349 -8948 49 7351 7352 -8949 49 7354 7355 -8950 49 7357 7358 -8951 49 7360 7361 -8952 49 7363 7364 -8953 49 7366 7367 -8954 49 7369 7370 -8955 49 7372 7373 -8956 49 7375 7376 -8957 49 7378 7379 -8958 49 7381 7382 -8959 49 7384 7385 -8960 49 7387 7388 -8961 49 7390 7391 -8962 49 7393 7394 -8963 49 7396 7397 -8964 49 7399 7400 -8965 49 7402 7403 -8966 49 7405 7406 -8967 49 7408 7409 -8968 49 7411 7412 -8969 49 7414 7415 -8970 49 7417 7418 -8971 49 7420 7421 -8972 49 7423 7424 -8973 49 7426 7427 -8974 49 7429 7430 -8975 49 7432 7433 -8976 49 7435 7436 -8977 49 7438 7439 -8978 49 7441 7442 -8979 49 7444 7445 -8980 49 7447 7448 -8981 49 7450 7451 -8982 49 7453 7454 -8983 49 7456 7457 -8984 49 7459 7460 -8985 49 7462 7463 -8986 49 7465 7466 -8987 49 7468 7469 -8988 49 7471 7472 -8989 49 7474 7475 -8990 49 7477 7478 -8991 49 7480 7481 -8992 49 7483 7484 -8993 49 7486 7487 -8994 49 7489 7490 -8995 49 7492 7493 -8996 49 7495 7496 -8997 49 7498 7499 -8998 49 7501 7502 -8999 49 7504 7505 -9000 49 7507 7508 -9001 49 7510 7511 -9002 49 7513 7514 -9003 49 7516 7517 -9004 49 7519 7520 -9005 49 7522 7523 -9006 49 7525 7526 -9007 49 7528 7529 -9008 49 7531 7532 -9009 49 7534 7535 -9010 49 7537 7538 -9011 49 7540 7541 -9012 49 7543 7544 -9013 49 7546 7547 -9014 49 7549 7550 -9015 49 7552 7553 -9016 49 7555 7556 -9017 49 7558 7559 -9018 49 7561 7562 -9019 49 7564 7565 -9020 49 7567 7568 -9021 49 7570 7571 -9022 49 7573 7574 -9023 49 7576 7577 -9024 49 7579 7580 -9025 49 7582 7583 -9026 49 7585 7586 -9027 49 7588 7589 -9028 49 7591 7592 -9029 49 7594 7595 -9030 49 7597 7598 -9031 49 7600 7601 -9032 49 7603 7604 -9033 49 7606 7607 -9034 49 7609 7610 -9035 49 7612 7613 -9036 49 7615 7616 -9037 49 7618 7619 -9038 49 7621 7622 -9039 49 7624 7625 -9040 49 7627 7628 -9041 49 7630 7631 -9042 49 7633 7634 -9043 49 7636 7637 -9044 49 7639 7640 -9045 49 7642 7643 -9046 49 7645 7646 -9047 49 7648 7649 -9048 49 7651 7652 -9049 49 7654 7655 -9050 49 7657 7658 -9051 49 7660 7661 -9052 49 7663 7664 -9053 49 7666 7667 -9054 49 7669 7670 -9055 49 7672 7673 -9056 49 7675 7676 -9057 49 7678 7679 -9058 49 7681 7682 -9059 49 7684 7685 -9060 49 7687 7688 -9061 49 7690 7691 -9062 49 7693 7694 -9063 49 7696 7697 -9064 49 7699 7700 -9065 49 7702 7703 -9066 49 7705 7706 -9067 49 7708 7709 -9068 49 7711 7712 -9069 49 7714 7715 -9070 49 7717 7718 -9071 49 7720 7721 -9072 49 7723 7724 -9073 49 7726 7727 -9074 49 7729 7730 -9075 49 7732 7733 -9076 49 7735 7736 -9077 49 7738 7739 -9078 49 7741 7742 -9079 49 7744 7745 -9080 49 7747 7748 -9081 49 7750 7751 -9082 49 7753 7754 -9083 49 7756 7757 -9084 49 7759 7760 -9085 49 7762 7763 -9086 49 7765 7766 -9087 49 7768 7769 -9088 49 7771 7772 -9089 49 7774 7775 -9090 49 7777 7778 -9091 49 7780 7781 -9092 49 7783 7784 -9093 49 7786 7787 -9094 49 7789 7790 -9095 49 7792 7793 -9096 49 7795 7796 -9097 49 7798 7799 -9098 49 7801 7802 -9099 49 7804 7805 -9100 49 7807 7808 -9101 49 7810 7811 -9102 49 7813 7814 -9103 49 7816 7817 -9104 49 7819 7820 -9105 49 7822 7823 -9106 49 7825 7826 -9107 49 7828 7829 -9108 49 7831 7832 -9109 49 7834 7835 -9110 49 7837 7838 -9111 49 7840 7841 -9112 49 7843 7844 -9113 49 7846 7847 -9114 49 7849 7850 -9115 49 7852 7853 -9116 49 7855 7856 -9117 49 7858 7859 -9118 49 7861 7862 -9119 49 7864 7865 -9120 49 7867 7868 -9121 49 7870 7871 -9122 49 7873 7874 -9123 49 7876 7877 -9124 49 7879 7880 -9125 49 7882 7883 -9126 49 7885 7886 -9127 49 7888 7889 -9128 49 7891 7892 -9129 49 7894 7895 -9130 49 7897 7898 -9131 49 7900 7901 -9132 49 7903 7904 -9133 49 7906 7907 -9134 49 7909 7910 -9135 49 7912 7913 -9136 49 7915 7916 -9137 49 7918 7919 -9138 49 7921 7922 -9139 49 7924 7925 -9140 49 7927 7928 -9141 49 7930 7931 -9142 49 7933 7934 -9143 49 7936 7937 -9144 49 7939 7940 -9145 49 7942 7943 -9146 49 7945 7946 -9147 49 7948 7949 -9148 49 7951 7952 -9149 49 7954 7955 -9150 49 7957 7958 -9151 49 7960 7961 -9152 49 7963 7964 -9153 49 7966 7967 -9154 49 7969 7970 -9155 49 7972 7973 -9156 49 7975 7976 -9157 49 7978 7979 -9158 49 7981 7982 -9159 49 7984 7985 -9160 49 7987 7988 -9161 49 7990 7991 -9162 49 7993 7994 -9163 49 7996 7997 -9164 49 7999 8000 -9165 49 8002 8003 -9166 49 8005 8006 -9167 49 8008 8009 -9168 49 8011 8012 -9169 49 8014 8015 -9170 49 8017 8018 -9171 49 8020 8021 -9172 49 8023 8024 -9173 49 8026 8027 -9174 49 8029 8030 -9175 49 8032 8033 -9176 49 8035 8036 -9177 49 8038 8039 -9178 49 8041 8042 -9179 49 8044 8045 -9180 49 8047 8048 -9181 49 8050 8051 -9182 49 8053 8054 -9183 49 8056 8057 -9184 49 8059 8060 -9185 49 8062 8063 -9186 49 8065 8066 -9187 49 8068 8069 -9188 49 8071 8072 -9189 49 8074 8075 -9190 49 8077 8078 -9191 49 8080 8081 -9192 49 8083 8084 -9193 49 8086 8087 -9194 49 8089 8090 -9195 49 8092 8093 -9196 49 8095 8096 -9197 49 8098 8099 -9198 49 8101 8102 -9199 49 8104 8105 -9200 49 8107 8108 -9201 49 8110 8111 -9202 49 8113 8114 -9203 49 8116 8117 -9204 49 8119 8120 -9205 49 8122 8123 -9206 49 8125 8126 -9207 49 8128 8129 -9208 49 8131 8132 -9209 49 8134 8135 -9210 49 8137 8138 -9211 49 8140 8141 -9212 49 8143 8144 -9213 49 8146 8147 -9214 49 8149 8150 -9215 49 8152 8153 -9216 49 8155 8156 -9217 49 8158 8159 -9218 49 8161 8162 -9219 49 8164 8165 -9220 49 8167 8168 -9221 49 8170 8171 -9222 49 8173 8174 -9223 49 8176 8177 -9224 49 8179 8180 -9225 49 8182 8183 -9226 49 8185 8186 -9227 49 8188 8189 -9228 49 8191 8192 -9229 49 8194 8195 -9230 49 8197 8198 -9231 49 8200 8201 -9232 49 8203 8204 -9233 49 8206 8207 -9234 49 8209 8210 -9235 49 8212 8213 -9236 49 8215 8216 -9237 49 8218 8219 -9238 49 8221 8222 -9239 49 8224 8225 -9240 49 8227 8228 -9241 49 8230 8231 -9242 49 8233 8234 -9243 49 8236 8237 -9244 49 8239 8240 -9245 49 8242 8243 -9246 49 8245 8246 -9247 49 8248 8249 -9248 49 8251 8252 -9249 49 8254 8255 -9250 49 8257 8258 -9251 49 8260 8261 -9252 49 8263 8264 -9253 49 8266 8267 -9254 49 8269 8270 -9255 49 8272 8273 -9256 49 8275 8276 -9257 49 8278 8279 -9258 49 8281 8282 -9259 49 8284 8285 -9260 49 8287 8288 -9261 49 8290 8291 -9262 49 8293 8294 -9263 49 8296 8297 -9264 49 8299 8300 -9265 49 8302 8303 -9266 49 8305 8306 -9267 49 8308 8309 -9268 49 8311 8312 -9269 49 8314 8315 -9270 49 8317 8318 -9271 49 8320 8321 -9272 49 8323 8324 -9273 49 8326 8327 -9274 49 8329 8330 -9275 49 8332 8333 -9276 49 8335 8336 -9277 49 8338 8339 -9278 49 8341 8342 -9279 49 8344 8345 -9280 49 8347 8348 -9281 49 8350 8351 -9282 49 8353 8354 -9283 49 8356 8357 -9284 49 8359 8360 -9285 49 8362 8363 -9286 49 8365 8366 -9287 49 8368 8369 -9288 49 8371 8372 -9289 49 8374 8375 -9290 49 8377 8378 -9291 49 8380 8381 -9292 49 8383 8384 -9293 49 8386 8387 -9294 49 8389 8390 -9295 49 8392 8393 -9296 49 8395 8396 -9297 49 8398 8399 -9298 49 8401 8402 -9299 49 8404 8405 -9300 49 8407 8408 -9301 49 8410 8411 -9302 49 8413 8414 -9303 49 8416 8417 -9304 49 8419 8420 -9305 49 8422 8423 -9306 49 8425 8426 -9307 49 8428 8429 -9308 49 8431 8432 -9309 49 8434 8435 -9310 49 8437 8438 -9311 49 8440 8441 -9312 49 8443 8444 -9313 49 8446 8447 -9314 49 8449 8450 -9315 49 8452 8453 -9316 49 8455 8456 -9317 49 8458 8459 -9318 49 8461 8462 -9319 49 8464 8465 -9320 49 8467 8468 -9321 49 8470 8471 -9322 49 8473 8474 -9323 49 8476 8477 -9324 49 8479 8480 -9325 49 8482 8483 -9326 49 8485 8486 -9327 49 8488 8489 -9328 49 8491 8492 -9329 49 8494 8495 -9330 49 8497 8498 -9331 49 8500 8501 -9332 49 8503 8504 -9333 49 8506 8507 -9334 49 8509 8510 -9335 49 8512 8513 -9336 49 8515 8516 -9337 49 8518 8519 -9338 49 8521 8522 -9339 49 8524 8525 -9340 49 8527 8528 -9341 49 8530 8531 -9342 49 8533 8534 -9343 49 8536 8537 -9344 49 8539 8540 -9345 49 8542 8543 -9346 49 8545 8546 -9347 49 8548 8549 -9348 49 8551 8552 -9349 49 8554 8555 -9350 49 8557 8558 -9351 49 8560 8561 -9352 49 8563 8564 -9353 49 8566 8567 -9354 49 8569 8570 -9355 49 8572 8573 -9356 49 8575 8576 -9357 49 8578 8579 -9358 49 8581 8582 -9359 49 8584 8585 -9360 49 8587 8588 -9361 49 8590 8591 -9362 49 8593 8594 -9363 49 8596 8597 -9364 49 8599 8600 -9365 49 8602 8603 -9366 49 8605 8606 -9367 49 8608 8609 -9368 49 8611 8612 -9369 49 8614 8615 -9370 49 8617 8618 -9371 49 8620 8621 -9372 49 8623 8624 -9373 49 8626 8627 -9374 49 8629 8630 -9375 49 8632 8633 -9376 49 8635 8636 -9377 49 8638 8639 -9378 49 8641 8642 -9379 49 8644 8645 -9380 49 8647 8648 -9381 49 8650 8651 -9382 49 8653 8654 -9383 49 8656 8657 -9384 49 8659 8660 -9385 49 8662 8663 -9386 49 8665 8666 -9387 49 8668 8669 -9388 49 8671 8672 -9389 49 8674 8675 -9390 49 8677 8678 -9391 49 8680 8681 -9392 49 8683 8684 -9393 49 8686 8687 -9394 49 8689 8690 -9395 49 8692 8693 -9396 49 8695 8696 -9397 49 8698 8699 -9398 49 8701 8702 -9399 49 8704 8705 -9400 49 8707 8708 -9401 49 8710 8711 -9402 49 8713 8714 -9403 49 8716 8717 -9404 49 8719 8720 -9405 49 8722 8723 -9406 49 8725 8726 -9407 49 8728 8729 -9408 49 8731 8732 -9409 49 8734 8735 -9410 49 8737 8738 -9411 49 8740 8741 -9412 49 8743 8744 -9413 49 8746 8747 -9414 49 8749 8750 -9415 49 8752 8753 -9416 49 8755 8756 -9417 49 8758 8759 -9418 49 8761 8762 -9419 49 8764 8765 -9420 49 8767 8768 -9421 49 8770 8771 -9422 49 8773 8774 -9423 49 8776 8777 -9424 49 8779 8780 -9425 49 8782 8783 -9426 49 8785 8786 -9427 49 8788 8789 -9428 49 8791 8792 -9429 49 8794 8795 -9430 49 8797 8798 -9431 49 8800 8801 -9432 49 8803 8804 -9433 49 8806 8807 -9434 49 8809 8810 -9435 49 8812 8813 -9436 49 8815 8816 -9437 49 8818 8819 -9438 49 8821 8822 -9439 49 8824 8825 -9440 49 8827 8828 -9441 49 8830 8831 -9442 49 8833 8834 -9443 49 8836 8837 -9444 49 8839 8840 -9445 49 8842 8843 -9446 49 8845 8846 -9447 49 8848 8849 -9448 49 8851 8852 -9449 49 8854 8855 -9450 49 8857 8858 -9451 49 8860 8861 -9452 49 8863 8864 -9453 49 8866 8867 -9454 49 8869 8870 -9455 49 8872 8873 -9456 49 8875 8876 -9457 49 8878 8879 -9458 49 8881 8882 -9459 49 8884 8885 -9460 49 8887 8888 -9461 49 8890 8891 -9462 49 8893 8894 -9463 49 8896 8897 -9464 49 8899 8900 -9465 49 8902 8903 -9466 49 8905 8906 -9467 49 8908 8909 -9468 49 8911 8912 -9469 49 8914 8915 -9470 49 8917 8918 -9471 49 8920 8921 -9472 49 8923 8924 -9473 49 8926 8927 -9474 49 8929 8930 -9475 49 8932 8933 -9476 49 8935 8936 -9477 49 8938 8939 -9478 49 8941 8942 -9479 49 8944 8945 -9480 49 8947 8948 -9481 49 8950 8951 -9482 49 8953 8954 -9483 49 8956 8957 -9484 49 8959 8960 -9485 49 8962 8963 -9486 49 8965 8966 -9487 49 8968 8969 -9488 49 8971 8972 -9489 49 8974 8975 -9490 49 8977 8978 -9491 49 8980 8981 -9492 49 8983 8984 -9493 49 8986 8987 -9494 49 8989 8990 -9495 49 8992 8993 -9496 49 8995 8996 -9497 49 8998 8999 -9498 49 9001 9002 -9499 49 9004 9005 -9500 49 9007 9008 -9501 49 9010 9011 -9502 49 9013 9014 -9503 49 9016 9017 -9504 49 9019 9020 -9505 49 9022 9023 -9506 49 9025 9026 -9507 49 9028 9029 -9508 49 9031 9032 -9509 49 9034 9035 -9510 49 9037 9038 -9511 49 9040 9041 -9512 49 9043 9044 -9513 49 9046 9047 -9514 49 9049 9050 -9515 49 9052 9053 -9516 49 9055 9056 -9517 49 9058 9059 -9518 49 9061 9062 -9519 49 9064 9065 -9520 49 9067 9068 -9521 49 9070 9071 -9522 49 9073 9074 -9523 49 9076 9077 -9524 49 9079 9080 -9525 49 9082 9083 -9526 49 9085 9086 -9527 49 9088 9089 -9528 49 9091 9092 -9529 49 9094 9095 -9530 49 9097 9098 -9531 49 9100 9101 -9532 49 9103 9104 -9533 49 9106 9107 -9534 49 9109 9110 -9535 49 9112 9113 -9536 49 9115 9116 -9537 49 9118 9119 -9538 49 9121 9122 -9539 49 9124 9125 -9540 49 9127 9128 -9541 49 9130 9131 -9542 49 9133 9134 -9543 49 9136 9137 -9544 49 9139 9140 -9545 49 9142 9143 -9546 49 9145 9146 -9547 49 9148 9149 -9548 49 9151 9152 -9549 49 9154 9155 -9550 49 9157 9158 -9551 49 9160 9161 -9552 49 9163 9164 -9553 49 9166 9167 -9554 49 9169 9170 -9555 49 9172 9173 -9556 49 9175 9176 -9557 49 9178 9179 -9558 49 9181 9182 -9559 49 9184 9185 -9560 49 9187 9188 -9561 49 9190 9191 -9562 49 9193 9194 -9563 49 9196 9197 -9564 49 9199 9200 -9565 49 9202 9203 -9566 49 9205 9206 -9567 49 9208 9209 -9568 49 9211 9212 -9569 49 9214 9215 -9570 49 9217 9218 -9571 49 9220 9221 -9572 49 9223 9224 -9573 49 9226 9227 -9574 49 9229 9230 -9575 49 9232 9233 -9576 49 9235 9236 -9577 49 9238 9239 -9578 49 9241 9242 -9579 49 9244 9245 -9580 49 9247 9248 -9581 49 9250 9251 -9582 49 9253 9254 -9583 49 9256 9257 -9584 49 9259 9260 -9585 49 9262 9263 -9586 49 9265 9266 -9587 49 9268 9269 -9588 49 9271 9272 -9589 49 9274 9275 -9590 49 9277 9278 -9591 49 9280 9281 -9592 49 9283 9284 -9593 49 9286 9287 -9594 49 9289 9290 -9595 49 9292 9293 -9596 49 9295 9296 -9597 49 9298 9299 -9598 49 9301 9302 -9599 49 9304 9305 -9600 49 9307 9308 -9601 49 9310 9311 -9602 49 9313 9314 -9603 49 9316 9317 -9604 49 9319 9320 -9605 49 9322 9323 -9606 49 9325 9326 -9607 49 9328 9329 -9608 49 9331 9332 -9609 49 9334 9335 -9610 49 9337 9338 -9611 49 9340 9341 -9612 49 9343 9344 -9613 49 9346 9347 -9614 49 9349 9350 -9615 49 9352 9353 -9616 49 9355 9356 -9617 49 9358 9359 -9618 49 9361 9362 -9619 49 9364 9365 -9620 49 9367 9368 -9621 49 9370 9371 -9622 49 9373 9374 -9623 49 9376 9377 -9624 49 9379 9380 -9625 49 9382 9383 -9626 49 9385 9386 -9627 49 9388 9389 -9628 49 9391 9392 -9629 49 9394 9395 -9630 49 9397 9398 -9631 49 9400 9401 -9632 49 9403 9404 -9633 49 9406 9407 -9634 49 9409 9410 -9635 49 9412 9413 -9636 49 9415 9416 -9637 49 9418 9419 -9638 49 9421 9422 -9639 49 9424 9425 -9640 49 9427 9428 -9641 49 9430 9431 -9642 49 9433 9434 -9643 49 9436 9437 -9644 49 9439 9440 -9645 49 9442 9443 -9646 49 9445 9446 -9647 49 9448 9449 -9648 49 9451 9452 -9649 49 9454 9455 -9650 49 9457 9458 -9651 49 9460 9461 -9652 49 9463 9464 -9653 49 9466 9467 -9654 49 9469 9470 -9655 49 9472 9473 -9656 49 9475 9476 -9657 49 9478 9479 -9658 49 9481 9482 -9659 49 9484 9485 -9660 49 9487 9488 -9661 49 9490 9491 -9662 49 9493 9494 -9663 49 9496 9497 -9664 49 9499 9500 -9665 49 9502 9503 -9666 49 9505 9506 -9667 49 9508 9509 -9668 49 9511 9512 -9669 49 9514 9515 -9670 49 9517 9518 -9671 49 9520 9521 -9672 49 9523 9524 -9673 49 9526 9527 -9674 49 9529 9530 -9675 49 9532 9533 -9676 49 9535 9536 -9677 49 9538 9539 -9678 49 9541 9542 -9679 49 9544 9545 -9680 49 9547 9548 -9681 49 9550 9551 -9682 49 9553 9554 -9683 49 9556 9557 -9684 49 9559 9560 -9685 49 9562 9563 -9686 49 9565 9566 -9687 49 9568 9569 -9688 49 9571 9572 -9689 49 9574 9575 -9690 49 9577 9578 -9691 49 9580 9581 -9692 49 9583 9584 -9693 49 9586 9587 -9694 49 9589 9590 -9695 49 9592 9593 -9696 49 9595 9596 -9697 49 9598 9599 -9698 49 9601 9602 -9699 49 9604 9605 -9700 49 9607 9608 -9701 49 9610 9611 -9702 49 9613 9614 -9703 49 9616 9617 -9704 49 9619 9620 -9705 49 9622 9623 -9706 49 9625 9626 -9707 49 9628 9629 -9708 49 9631 9632 -9709 49 9634 9635 -9710 49 9637 9638 -9711 49 9640 9641 -9712 49 9643 9644 -9713 49 9646 9647 -9714 49 9649 9650 -9715 49 9652 9653 -9716 49 9655 9656 -9717 49 9658 9659 -9718 49 9661 9662 -9719 49 9664 9665 -9720 49 9667 9668 -9721 49 9670 9671 -9722 49 9673 9674 -9723 49 9676 9677 -9724 49 9679 9680 -9725 49 9682 9683 -9726 49 9685 9686 -9727 49 9688 9689 -9728 49 9691 9692 -9729 49 9694 9695 -9730 49 9697 9698 -9731 49 9700 9701 -9732 49 9703 9704 -9733 49 9706 9707 -9734 49 9709 9710 -9735 49 9712 9713 -9736 49 9715 9716 -9737 49 9718 9719 -9738 49 9721 9722 -9739 49 9724 9725 -9740 49 9727 9728 -9741 49 9730 9731 -9742 49 9733 9734 -9743 49 9736 9737 - -Angles - -1 1 2 1 5 -2 1 2 1 6 -3 1 2 1 7 -4 2 6 1 5 -5 2 7 1 5 -6 2 7 1 6 -7 3 3 2 1 -8 4 8 2 1 -9 5 9 2 1 -10 6 3 2 8 -11 7 3 2 9 -12 8 8 2 9 -13 9 4 3 2 -14 10 20 3 2 -15 11 20 3 4 -16 12 2 9 10 -17 13 2 9 13 -18 13 2 9 14 -19 14 10 9 13 -20 14 10 9 14 -21 15 14 9 13 -22 16 9 10 11 -23 14 9 10 15 -24 14 9 10 16 -25 17 15 10 11 -26 17 16 10 11 -27 15 16 10 15 -28 18 12 11 10 -29 19 17 12 11 -30 19 18 12 11 -31 19 19 12 11 -32 15 18 12 17 -33 15 19 12 17 -34 15 19 12 18 -35 20 3 20 21 -36 21 3 20 24 -37 22 24 20 21 -38 23 20 21 22 -39 24 20 21 25 -40 25 20 21 26 -41 6 22 21 25 -42 7 22 21 26 -43 8 25 21 26 -44 9 23 22 21 -45 10 37 22 21 -46 11 37 22 23 -47 12 21 26 27 -48 13 21 26 31 -49 13 21 26 32 -50 14 27 26 31 -51 14 27 26 32 -52 15 32 26 31 -53 26 28 27 26 -54 14 26 27 33 -55 14 26 27 34 -56 27 28 27 33 -57 27 28 27 34 -58 15 34 27 33 -59 28 29 28 27 -60 29 30 28 27 -61 11 30 28 29 -62 21 28 30 35 -63 21 28 30 36 -64 30 36 30 35 -65 20 22 37 38 -66 21 22 37 41 -67 22 41 37 38 -68 23 37 38 39 -69 24 37 38 42 -70 31 37 38 43 -71 6 39 38 42 -72 32 39 38 43 -73 33 42 38 43 -74 9 40 39 38 -75 10 56 39 38 -76 11 56 39 40 -77 34 38 43 44 -78 34 38 43 45 -79 33 47 43 38 -80 35 45 43 44 -81 8 47 43 44 -82 8 47 43 45 -83 12 43 44 46 -84 13 43 44 48 -85 13 43 44 49 -86 14 46 44 48 -87 14 46 44 49 -88 15 49 44 48 -89 13 43 45 50 -90 13 43 45 51 -91 13 43 45 52 -92 15 51 45 50 -93 15 52 45 50 -94 15 52 45 51 -95 14 44 46 53 -96 14 44 46 54 -97 14 44 46 55 -98 15 54 46 53 -99 15 55 46 53 -100 15 55 46 54 -101 20 39 56 57 -102 21 39 56 60 -103 22 60 56 57 -104 23 56 57 58 -105 24 56 57 61 -106 25 56 57 62 -107 6 58 57 61 -108 7 58 57 62 -109 8 61 57 62 -110 9 59 58 57 -111 10 76 58 57 -112 11 76 58 59 -113 36 57 62 63 -114 13 57 62 69 -115 13 57 62 70 -116 37 69 62 63 -117 37 70 62 63 -118 15 70 62 69 -119 38 62 63 64 -120 38 62 63 65 -121 39 65 63 64 -122 39 66 64 63 -123 40 63 64 71 -124 40 66 64 71 -125 39 67 65 63 -126 40 63 65 72 -127 40 67 65 72 -128 39 68 66 64 -129 40 64 66 73 -130 40 68 66 73 -131 39 68 67 65 -132 40 65 67 74 -133 40 68 67 74 -134 39 67 68 66 -135 40 66 68 75 -136 40 67 68 75 -137 20 58 76 77 -138 21 58 76 80 -139 22 80 76 77 -140 23 76 77 78 -141 24 76 77 81 -142 31 76 77 82 -143 6 78 77 81 -144 32 78 77 82 -145 33 81 77 82 -146 9 79 78 77 -147 10 92 78 77 -148 11 92 78 79 -149 34 77 82 83 -150 34 77 82 84 -151 33 85 82 77 -152 35 84 82 83 -153 8 85 82 83 -154 8 85 82 84 -155 13 82 83 86 -156 13 82 83 87 -157 13 82 83 88 -158 15 87 83 86 -159 15 88 83 86 -160 15 88 83 87 -161 13 82 84 89 -162 13 82 84 90 -163 13 82 84 91 -164 15 90 84 89 -165 15 91 84 89 -166 15 91 84 90 -167 20 78 92 93 -168 21 78 92 96 -169 22 96 92 93 -170 23 92 93 94 -171 24 92 93 97 -172 25 92 93 98 -173 6 94 93 97 -174 7 94 93 98 -175 8 97 93 98 -176 9 95 94 93 -177 10 114 94 93 -178 11 114 94 95 -179 12 93 98 99 -180 13 93 98 103 -181 13 93 98 104 -182 14 99 98 103 -183 14 99 98 104 -184 15 104 98 103 -185 41 100 99 98 -186 14 98 99 105 -187 14 98 99 106 -188 14 100 99 105 -189 14 100 99 106 -190 15 106 99 105 -191 41 101 100 99 -192 14 99 100 107 -193 14 99 100 108 -194 14 101 100 107 -195 14 101 100 108 -196 15 108 100 107 -197 42 100 101 102 -198 14 100 101 109 -199 14 100 101 110 -200 43 109 101 102 -201 43 110 101 102 -202 15 110 101 109 -203 44 101 102 111 -204 44 101 102 112 -205 44 101 102 113 -206 45 112 102 111 -207 45 113 102 111 -208 45 113 102 112 -209 20 94 114 115 -210 21 94 114 118 -211 22 118 114 115 -212 23 114 115 116 -213 24 114 115 119 -214 31 114 115 120 -215 6 116 115 119 -216 32 116 115 120 -217 33 119 115 120 -218 9 117 116 115 -219 10 128 116 115 -220 11 128 116 117 -221 46 115 120 121 -222 34 115 120 122 -223 33 123 120 115 -224 47 122 120 121 -225 48 123 120 121 -226 8 123 120 122 -227 49 120 121 124 -228 13 120 122 125 -229 13 120 122 126 -230 13 120 122 127 -231 15 126 122 125 -232 15 127 122 125 -233 15 127 122 126 -234 20 116 128 129 -235 21 116 128 132 -236 22 132 128 129 -237 23 128 129 130 -238 24 128 129 133 -239 25 128 129 134 -240 6 130 129 133 -241 7 130 129 134 -242 8 133 129 134 -243 9 131 130 129 -244 10 147 130 129 -245 11 147 130 131 -246 50 135 134 129 -247 13 129 134 138 -248 13 129 134 139 -249 13 135 134 138 -250 13 135 134 139 -251 15 139 134 138 -252 35 136 135 134 -253 35 137 135 134 -254 8 140 135 134 -255 35 137 135 136 -256 8 140 135 136 -257 8 140 135 137 -258 13 135 136 141 -259 13 135 136 142 -260 13 135 136 143 -261 15 142 136 141 -262 15 143 136 141 -263 15 143 136 142 -264 13 135 137 144 -265 13 135 137 145 -266 13 135 137 146 -267 15 145 137 144 -268 15 146 137 144 -269 15 146 137 145 -270 20 130 147 148 -271 21 130 147 151 -272 22 151 147 148 -273 23 147 148 149 -274 24 147 148 152 -275 31 147 148 153 -276 6 149 148 152 -277 32 149 148 153 -278 33 152 148 153 -279 9 150 149 148 -280 10 161 149 148 -281 11 161 149 150 -282 46 148 153 154 -283 34 148 153 155 -284 33 156 153 148 -285 47 155 153 154 -286 48 156 153 154 -287 8 156 153 155 -288 49 153 154 157 -289 13 153 155 158 -290 13 153 155 159 -291 13 153 155 160 -292 15 159 155 158 -293 15 160 155 158 -294 15 160 155 159 -295 51 162 161 149 -296 21 149 161 165 -297 52 162 161 165 -298 53 161 162 163 -299 54 161 162 166 -300 54 161 162 167 -301 55 163 162 166 -302 55 163 162 167 -303 56 167 162 166 -304 57 162 163 164 -305 58 168 163 162 -306 11 168 163 164 -307 20 163 168 169 -308 21 163 168 172 -309 22 172 168 169 -310 23 168 169 170 -311 24 168 169 173 -312 25 168 169 174 -313 6 170 169 173 -314 7 170 169 174 -315 8 173 169 174 -316 9 171 170 169 -317 10 190 170 169 -318 11 190 170 171 -319 12 169 174 175 -320 13 169 174 179 -321 13 169 174 180 -322 14 175 174 179 -323 14 175 174 180 -324 15 180 174 179 -325 41 176 175 174 -326 14 174 175 181 -327 14 174 175 182 -328 14 176 175 181 -329 14 176 175 182 -330 15 182 175 181 -331 41 177 176 175 -332 14 175 176 183 -333 14 175 176 184 -334 14 177 176 183 -335 14 177 176 184 -336 15 184 176 183 -337 42 176 177 178 -338 14 176 177 185 -339 14 176 177 186 -340 43 185 177 178 -341 43 186 177 178 -342 15 186 177 185 -343 44 177 178 187 -344 44 177 178 188 -345 44 177 178 189 -346 45 188 178 187 -347 45 189 178 187 -348 45 189 178 188 -349 20 170 190 191 -350 21 170 190 194 -351 22 194 190 191 -352 23 190 191 192 -353 24 190 191 195 -354 31 190 191 196 -355 6 192 191 195 -356 32 192 191 196 -357 33 195 191 196 -358 9 193 192 191 -359 10 204 192 191 -360 11 204 192 193 -361 46 191 196 197 -362 34 191 196 198 -363 33 199 196 191 -364 47 198 196 197 -365 48 199 196 197 -366 8 199 196 198 -367 49 196 197 200 -368 13 196 198 201 -369 13 196 198 202 -370 13 196 198 203 -371 15 202 198 201 -372 15 203 198 201 -373 15 203 198 202 -374 20 192 204 205 -375 21 192 204 208 -376 22 208 204 205 -377 23 204 205 206 -378 24 204 205 209 -379 31 204 205 210 -380 6 206 205 209 -381 32 206 205 210 -382 33 209 205 210 -383 9 207 206 205 -384 10 223 206 205 -385 11 223 206 207 -386 34 205 210 211 -387 34 205 210 212 -388 33 214 210 205 -389 35 212 210 211 -390 8 214 210 211 -391 8 214 210 212 -392 12 210 211 213 -393 13 210 211 215 -394 13 210 211 216 -395 14 213 211 215 -396 14 213 211 216 -397 15 216 211 215 -398 13 210 212 217 -399 13 210 212 218 -400 13 210 212 219 -401 15 218 212 217 -402 15 219 212 217 -403 15 219 212 218 -404 14 211 213 220 -405 14 211 213 221 -406 14 211 213 222 -407 15 221 213 220 -408 15 222 213 220 -409 15 222 213 221 -410 20 206 223 224 -411 21 206 223 227 -412 22 227 223 224 -413 23 223 224 225 -414 24 223 224 228 -415 31 223 224 229 -416 6 225 224 228 -417 32 225 224 229 -418 33 228 224 229 -419 9 226 225 224 -420 10 237 225 224 -421 11 237 225 226 -422 46 224 229 230 -423 34 224 229 231 -424 33 232 229 224 -425 47 231 229 230 -426 48 232 229 230 -427 8 232 229 231 -428 49 229 230 233 -429 13 229 231 234 -430 13 229 231 235 -431 13 229 231 236 -432 15 235 231 234 -433 15 236 231 234 -434 15 236 231 235 -435 20 225 237 238 -436 21 225 237 241 -437 22 241 237 238 -438 23 237 238 239 -439 24 237 238 242 -440 25 237 238 243 -441 6 239 238 242 -442 7 239 238 243 -443 8 242 238 243 -444 9 240 239 238 -445 10 256 239 238 -446 11 256 239 240 -447 50 244 243 238 -448 13 238 243 247 -449 13 238 243 248 -450 13 244 243 247 -451 13 244 243 248 -452 15 248 243 247 -453 35 245 244 243 -454 35 246 244 243 -455 8 249 244 243 -456 35 246 244 245 -457 8 249 244 245 -458 8 249 244 246 -459 13 244 245 250 -460 13 244 245 251 -461 13 244 245 252 -462 15 251 245 250 -463 15 252 245 250 -464 15 252 245 251 -465 13 244 246 253 -466 13 244 246 254 -467 13 244 246 255 -468 15 254 246 253 -469 15 255 246 253 -470 15 255 246 254 -471 20 239 256 257 -472 21 239 256 260 -473 22 260 256 257 -474 23 256 257 258 -475 24 256 257 261 -476 25 256 257 262 -477 6 258 257 261 -478 7 258 257 262 -479 8 261 257 262 -480 9 259 258 257 -481 10 271 258 257 -482 11 271 258 259 -483 12 257 262 263 -484 13 257 262 267 -485 13 257 262 268 -486 14 263 262 267 -487 14 263 262 268 -488 15 268 262 267 -489 59 262 263 264 -490 14 262 263 269 -491 14 262 263 270 -492 60 269 263 264 -493 60 270 263 264 -494 15 270 263 269 -495 61 263 264 265 -496 61 263 264 266 -497 62 266 264 265 -498 20 258 271 272 -499 21 258 271 275 -500 22 275 271 272 -501 23 271 272 273 -502 24 271 272 276 -503 31 271 272 277 -504 6 273 272 276 -505 32 273 272 277 -506 33 276 272 277 -507 9 274 273 272 -508 10 287 273 272 -509 11 287 273 274 -510 34 272 277 278 -511 34 272 277 279 -512 33 280 277 272 -513 35 279 277 278 -514 8 280 277 278 -515 8 280 277 279 -516 13 277 278 281 -517 13 277 278 282 -518 13 277 278 283 -519 15 282 278 281 -520 15 283 278 281 -521 15 283 278 282 -522 13 277 279 284 -523 13 277 279 285 -524 13 277 279 286 -525 15 285 279 284 -526 15 286 279 284 -527 15 286 279 285 -528 20 273 287 288 -529 21 273 287 291 -530 22 291 287 288 -531 23 287 288 289 -532 24 287 288 292 -533 25 287 288 293 -534 6 289 288 292 -535 7 289 288 293 -536 8 292 288 293 -537 9 290 289 288 -538 63 288 289 302 -539 64 290 289 302 -540 12 288 293 294 -541 13 288 293 298 -542 13 288 293 299 -543 14 294 293 298 -544 14 294 293 299 -545 15 299 293 298 -546 59 293 294 295 -547 14 293 294 300 -548 14 293 294 301 -549 60 300 294 295 -550 60 301 294 295 -551 15 301 294 300 -552 61 294 295 296 -553 61 294 295 297 -554 62 297 295 296 -555 65 289 302 303 -556 66 289 302 309 -557 67 303 302 309 -558 68 304 303 302 -559 69 306 303 302 -560 70 302 303 307 -561 6 304 303 306 -562 71 304 303 307 -563 72 306 303 307 -564 9 305 304 303 -565 10 316 304 303 -566 11 316 304 305 -567 73 303 307 308 -568 74 303 307 310 -569 74 303 307 311 -570 75 310 307 308 -571 75 311 307 308 -572 76 311 307 310 -573 77 309 308 307 -574 75 312 308 307 -575 75 313 308 307 -576 75 312 308 309 -577 75 313 308 309 -578 76 313 308 312 -579 78 302 309 308 -580 79 314 309 302 -581 79 315 309 302 -582 80 314 309 308 -583 80 315 309 308 -584 81 315 309 314 -585 20 304 316 317 -586 21 304 316 320 -587 22 320 316 317 -588 23 316 317 318 -589 24 316 317 321 -590 25 316 317 322 -591 6 318 317 321 -592 7 318 317 322 -593 8 321 317 322 -594 9 319 318 317 -595 10 327 318 317 -596 11 327 318 319 -597 82 317 322 323 -598 13 317 322 324 -599 13 317 322 325 -600 83 324 322 323 -601 83 325 322 323 -602 15 325 322 324 -603 84 322 323 326 -604 20 318 327 328 -605 21 318 327 331 -606 22 331 327 328 -607 23 327 328 329 -608 24 327 328 332 -609 25 327 328 333 -610 6 329 328 332 -611 7 329 328 333 -612 8 332 328 333 -613 9 330 329 328 -614 10 339 329 328 -615 11 339 329 330 -616 85 328 333 334 -617 13 328 333 337 -618 13 328 333 338 -619 60 337 333 334 -620 60 338 333 334 -621 15 338 333 337 -622 61 333 334 335 -623 61 333 334 336 -624 62 336 334 335 -625 20 329 339 340 -626 21 329 339 343 -627 22 343 339 340 -628 23 339 340 341 -629 24 339 340 344 -630 31 339 340 345 -631 6 341 340 344 -632 32 341 340 345 -633 33 344 340 345 -634 9 342 341 340 -635 10 353 341 340 -636 11 353 341 342 -637 46 340 345 346 -638 34 340 345 347 -639 33 348 345 340 -640 47 347 345 346 -641 48 348 345 346 -642 8 348 345 347 -643 49 345 346 349 -644 13 345 347 350 -645 13 345 347 351 -646 13 345 347 352 -647 15 351 347 350 -648 15 352 347 350 -649 15 352 347 351 -650 20 341 353 354 -651 21 341 353 357 -652 22 357 353 354 -653 23 353 354 355 -654 24 353 354 358 -655 31 353 354 359 -656 6 355 354 358 -657 32 355 354 359 -658 33 358 354 359 -659 9 356 355 354 -660 10 372 355 354 -661 11 372 355 356 -662 34 354 359 360 -663 34 354 359 361 -664 33 363 359 354 -665 35 361 359 360 -666 8 363 359 360 -667 8 363 359 361 -668 12 359 360 362 -669 13 359 360 364 -670 13 359 360 365 -671 14 362 360 364 -672 14 362 360 365 -673 15 365 360 364 -674 13 359 361 366 -675 13 359 361 367 -676 13 359 361 368 -677 15 367 361 366 -678 15 368 361 366 -679 15 368 361 367 -680 14 360 362 369 -681 14 360 362 370 -682 14 360 362 371 -683 15 370 362 369 -684 15 371 362 369 -685 15 371 362 370 -686 20 355 372 373 -687 21 355 372 376 -688 22 376 372 373 -689 23 372 373 374 -690 24 372 373 377 -691 25 372 373 378 -692 6 374 373 377 -693 7 374 373 378 -694 8 377 373 378 -695 9 375 374 373 -696 10 387 374 373 -697 11 387 374 375 -698 12 373 378 379 -699 13 373 378 383 -700 13 373 378 384 -701 14 379 378 383 -702 14 379 378 384 -703 15 384 378 383 -704 59 378 379 380 -705 14 378 379 385 -706 14 378 379 386 -707 60 385 379 380 -708 60 386 379 380 -709 15 386 379 385 -710 61 379 380 381 -711 61 379 380 382 -712 62 382 380 381 -713 20 374 387 388 -714 21 374 387 391 -715 22 391 387 388 -716 23 387 388 389 -717 24 387 388 392 -718 25 387 388 393 -719 6 389 388 392 -720 7 389 388 393 -721 8 392 388 393 -722 9 390 389 388 -723 10 401 389 388 -724 11 401 389 390 -725 86 394 393 388 -726 13 388 393 397 -727 13 388 393 398 -728 27 394 393 397 -729 27 394 393 398 -730 15 398 393 397 -731 28 395 394 393 -732 29 396 394 393 -733 11 396 394 395 -734 21 394 396 399 -735 21 394 396 400 -736 30 400 396 399 -737 20 389 401 402 -738 21 389 401 405 -739 22 405 401 402 -740 23 401 402 403 -741 24 401 402 406 -742 31 401 402 407 -743 6 403 402 406 -744 32 403 402 407 -745 33 406 402 407 -746 9 404 403 402 -747 10 417 403 402 -748 11 417 403 404 -749 34 402 407 408 -750 34 402 407 409 -751 33 410 407 402 -752 35 409 407 408 -753 8 410 407 408 -754 8 410 407 409 -755 13 407 408 411 -756 13 407 408 412 -757 13 407 408 413 -758 15 412 408 411 -759 15 413 408 411 -760 15 413 408 412 -761 13 407 409 414 -762 13 407 409 415 -763 13 407 409 416 -764 15 415 409 414 -765 15 416 409 414 -766 15 416 409 415 -767 20 403 417 418 -768 21 403 417 421 -769 22 421 417 418 -770 23 417 418 419 -771 24 417 418 422 -772 25 417 418 423 -773 6 419 418 422 -774 7 419 418 423 -775 8 422 418 423 -776 9 420 419 418 -777 10 439 419 418 -778 11 439 419 420 -779 12 418 423 424 -780 13 418 423 428 -781 13 418 423 429 -782 14 424 423 428 -783 14 424 423 429 -784 15 429 423 428 -785 41 425 424 423 -786 14 423 424 430 -787 14 423 424 431 -788 14 425 424 430 -789 14 425 424 431 -790 15 431 424 430 -791 41 426 425 424 -792 14 424 425 432 -793 14 424 425 433 -794 14 426 425 432 -795 14 426 425 433 -796 15 433 425 432 -797 42 425 426 427 -798 14 425 426 434 -799 14 425 426 435 -800 43 434 426 427 -801 43 435 426 427 -802 15 435 426 434 -803 44 426 427 436 -804 44 426 427 437 -805 44 426 427 438 -806 45 437 427 436 -807 45 438 427 436 -808 45 438 427 437 -809 20 419 439 440 -810 21 419 439 443 -811 22 443 439 440 -812 23 439 440 441 -813 24 439 440 444 -814 25 439 440 445 -815 6 441 440 444 -816 7 441 440 445 -817 8 444 440 445 -818 9 442 441 440 -819 10 449 441 440 -820 11 449 441 442 -821 13 440 445 446 -822 13 440 445 447 -823 13 440 445 448 -824 15 447 445 446 -825 15 448 445 446 -826 15 448 445 447 -827 20 441 449 450 -828 21 441 449 453 -829 22 453 449 450 -830 23 449 450 451 -831 24 449 450 454 -832 25 449 450 455 -833 6 451 450 454 -834 7 451 450 455 -835 8 454 450 455 -836 9 452 451 450 -837 10 471 451 450 -838 11 471 451 452 -839 12 450 455 456 -840 13 450 455 460 -841 13 450 455 461 -842 14 456 455 460 -843 14 456 455 461 -844 15 461 455 460 -845 41 457 456 455 -846 14 455 456 462 -847 14 455 456 463 -848 14 457 456 462 -849 14 457 456 463 -850 15 463 456 462 -851 41 458 457 456 -852 14 456 457 464 -853 14 456 457 465 -854 14 458 457 464 -855 14 458 457 465 -856 15 465 457 464 -857 42 457 458 459 -858 14 457 458 466 -859 14 457 458 467 -860 43 466 458 459 -861 43 467 458 459 -862 15 467 458 466 -863 44 458 459 468 -864 44 458 459 469 -865 44 458 459 470 -866 45 469 459 468 -867 45 470 459 468 -868 45 470 459 469 -869 20 451 471 472 -870 21 451 471 475 -871 22 475 471 472 -872 23 471 472 473 -873 24 471 472 476 -874 31 471 472 477 -875 6 473 472 476 -876 32 473 472 477 -877 33 476 472 477 -878 9 474 473 472 -879 10 490 473 472 -880 11 490 473 474 -881 34 472 477 478 -882 34 472 477 479 -883 33 481 477 472 -884 35 479 477 478 -885 8 481 477 478 -886 8 481 477 479 -887 12 477 478 480 -888 13 477 478 482 -889 13 477 478 483 -890 14 480 478 482 -891 14 480 478 483 -892 15 483 478 482 -893 13 477 479 484 -894 13 477 479 485 -895 13 477 479 486 -896 15 485 479 484 -897 15 486 479 484 -898 15 486 479 485 -899 14 478 480 487 -900 14 478 480 488 -901 14 478 480 489 -902 15 488 480 487 -903 15 489 480 487 -904 15 489 480 488 -905 20 473 490 491 -906 21 473 490 494 -907 22 494 490 491 -908 23 490 491 492 -909 24 490 491 495 -910 25 490 491 496 -911 6 492 491 495 -912 7 492 491 496 -913 8 495 491 496 -914 9 493 492 491 -915 10 507 492 491 -916 11 507 492 493 -917 12 491 496 497 -918 13 491 496 501 -919 13 491 496 502 -920 14 497 496 501 -921 14 497 496 502 -922 15 502 496 501 -923 26 498 497 496 -924 14 496 497 503 -925 14 496 497 504 -926 27 498 497 503 -927 27 498 497 504 -928 15 504 497 503 -929 28 499 498 497 -930 29 500 498 497 -931 11 500 498 499 -932 21 498 500 505 -933 21 498 500 506 -934 30 506 500 505 -935 20 492 507 508 -936 21 492 507 511 -937 22 511 507 508 -938 23 507 508 509 -939 24 507 508 512 -940 25 507 508 513 -941 6 509 508 512 -942 7 509 508 513 -943 8 512 508 513 -944 9 510 509 508 -945 10 519 509 508 -946 11 519 509 510 -947 85 508 513 514 -948 13 508 513 517 -949 13 508 513 518 -950 60 517 513 514 -951 60 518 513 514 -952 15 518 513 517 -953 61 513 514 515 -954 61 513 514 516 -955 62 516 514 515 -956 20 509 519 520 -957 21 509 519 523 -958 22 523 519 520 -959 23 519 520 521 -960 24 519 520 524 -961 25 519 520 525 -962 6 521 520 524 -963 7 521 520 525 -964 8 524 520 525 -965 9 522 521 520 -966 10 541 521 520 -967 11 541 521 522 -968 12 520 525 526 -969 13 520 525 530 -970 13 520 525 531 -971 14 526 525 530 -972 14 526 525 531 -973 15 531 525 530 -974 41 527 526 525 -975 14 525 526 532 -976 14 525 526 533 -977 14 527 526 532 -978 14 527 526 533 -979 15 533 526 532 -980 41 528 527 526 -981 14 526 527 534 -982 14 526 527 535 -983 14 528 527 534 -984 14 528 527 535 -985 15 535 527 534 -986 42 527 528 529 -987 14 527 528 536 -988 14 527 528 537 -989 43 536 528 529 -990 43 537 528 529 -991 15 537 528 536 -992 44 528 529 538 -993 44 528 529 539 -994 44 528 529 540 -995 45 539 529 538 -996 45 540 529 538 -997 45 540 529 539 -998 20 521 541 542 -999 21 521 541 545 -1000 22 545 541 542 -1001 23 541 542 543 -1002 24 541 542 546 -1003 25 541 542 547 -1004 6 543 542 546 -1005 7 543 542 547 -1006 8 546 542 547 -1007 9 544 543 542 -1008 10 556 543 542 -1009 11 556 543 544 -1010 12 542 547 548 -1011 13 542 547 552 -1012 13 542 547 553 -1013 14 548 547 552 -1014 14 548 547 553 -1015 15 553 547 552 -1016 59 547 548 549 -1017 14 547 548 554 -1018 14 547 548 555 -1019 60 554 548 549 -1020 60 555 548 549 -1021 15 555 548 554 -1022 61 548 549 550 -1023 61 548 549 551 -1024 62 551 549 550 -1025 51 557 556 543 -1026 21 543 556 560 -1027 52 557 556 560 -1028 53 556 557 558 -1029 54 556 557 561 -1030 54 556 557 562 -1031 55 558 557 561 -1032 55 558 557 562 -1033 56 562 557 561 -1034 57 557 558 559 -1035 58 563 558 557 -1036 11 563 558 559 -1037 20 558 563 564 -1038 21 558 563 567 -1039 22 567 563 564 -1040 23 563 564 565 -1041 24 563 564 568 -1042 31 563 564 569 -1043 6 565 564 568 -1044 32 565 564 569 -1045 33 568 564 569 -1046 9 566 565 564 -1047 63 564 565 582 -1048 64 566 565 582 -1049 34 564 569 570 -1050 34 564 569 571 -1051 33 573 569 564 -1052 35 571 569 570 -1053 8 573 569 570 -1054 8 573 569 571 -1055 12 569 570 572 -1056 13 569 570 574 -1057 13 569 570 575 -1058 14 572 570 574 -1059 14 572 570 575 -1060 15 575 570 574 -1061 13 569 571 576 -1062 13 569 571 577 -1063 13 569 571 578 -1064 15 577 571 576 -1065 15 578 571 576 -1066 15 578 571 577 -1067 14 570 572 579 -1068 14 570 572 580 -1069 14 570 572 581 -1070 15 580 572 579 -1071 15 581 572 579 -1072 15 581 572 580 -1073 65 565 582 583 -1074 66 565 582 589 -1075 67 583 582 589 -1076 68 584 583 582 -1077 69 586 583 582 -1078 70 582 583 587 -1079 6 584 583 586 -1080 71 584 583 587 -1081 72 586 583 587 -1082 9 585 584 583 -1083 63 583 584 596 -1084 64 585 584 596 -1085 73 583 587 588 -1086 74 583 587 590 -1087 74 583 587 591 -1088 75 590 587 588 -1089 75 591 587 588 -1090 76 591 587 590 -1091 77 589 588 587 -1092 75 592 588 587 -1093 75 593 588 587 -1094 75 592 588 589 -1095 75 593 588 589 -1096 76 593 588 592 -1097 78 582 589 588 -1098 79 594 589 582 -1099 79 595 589 582 -1100 80 594 589 588 -1101 80 595 589 588 -1102 81 595 589 594 -1103 65 584 596 597 -1104 66 584 596 603 -1105 67 597 596 603 -1106 68 598 597 596 -1107 69 600 597 596 -1108 70 596 597 601 -1109 6 598 597 600 -1110 71 598 597 601 -1111 72 600 597 601 -1112 9 599 598 597 -1113 10 610 598 597 -1114 11 610 598 599 -1115 73 597 601 602 -1116 74 597 601 604 -1117 74 597 601 605 -1118 75 604 601 602 -1119 75 605 601 602 -1120 76 605 601 604 -1121 77 603 602 601 -1122 75 606 602 601 -1123 75 607 602 601 -1124 75 606 602 603 -1125 75 607 602 603 -1126 76 607 602 606 -1127 78 596 603 602 -1128 79 608 603 596 -1129 79 609 603 596 -1130 80 608 603 602 -1131 80 609 603 602 -1132 81 609 603 608 -1133 20 598 610 611 -1134 21 598 610 614 -1135 22 614 610 611 -1136 23 610 611 612 -1137 24 610 611 615 -1138 25 610 611 616 -1139 6 612 611 615 -1140 7 612 611 616 -1141 8 615 611 616 -1142 9 613 612 611 -1143 10 622 612 611 -1144 11 622 612 613 -1145 85 611 616 617 -1146 13 611 616 620 -1147 13 611 616 621 -1148 60 620 616 617 -1149 60 621 616 617 -1150 15 621 616 620 -1151 61 616 617 618 -1152 61 616 617 619 -1153 62 619 617 618 -1154 20 612 622 623 -1155 21 612 622 626 -1156 22 626 622 623 -1157 23 622 623 624 -1158 24 622 623 627 -1159 25 622 623 628 -1160 6 624 623 627 -1161 7 624 623 628 -1162 8 627 623 628 -1163 9 625 624 623 -1164 10 639 624 623 -1165 11 639 624 625 -1166 12 623 628 629 -1167 13 623 628 633 -1168 13 623 628 634 -1169 14 629 628 633 -1170 14 629 628 634 -1171 15 634 628 633 -1172 26 630 629 628 -1173 14 628 629 635 -1174 14 628 629 636 -1175 27 630 629 635 -1176 27 630 629 636 -1177 15 636 629 635 -1178 28 631 630 629 -1179 29 632 630 629 -1180 11 632 630 631 -1181 21 630 632 637 -1182 21 630 632 638 -1183 30 638 632 637 -1184 20 624 639 640 -1185 21 624 639 643 -1186 22 643 639 640 -1187 23 639 640 641 -1188 24 639 640 644 -1189 25 639 640 645 -1190 6 641 640 644 -1191 7 641 640 645 -1192 8 644 640 645 -1193 9 642 641 640 -1194 10 656 641 640 -1195 11 656 641 642 -1196 12 640 645 646 -1197 13 640 645 650 -1198 13 640 645 651 -1199 14 646 645 650 -1200 14 646 645 651 -1201 15 651 645 650 -1202 26 647 646 645 -1203 14 645 646 652 -1204 14 645 646 653 -1205 27 647 646 652 -1206 27 647 646 653 -1207 15 653 646 652 -1208 28 648 647 646 -1209 29 649 647 646 -1210 11 649 647 648 -1211 21 647 649 654 -1212 21 647 649 655 -1213 30 655 649 654 -1214 20 641 656 657 -1215 21 641 656 660 -1216 22 660 656 657 -1217 23 656 657 658 -1218 24 656 657 661 -1219 25 656 657 662 -1220 6 658 657 661 -1221 7 658 657 662 -1222 8 661 657 662 -1223 9 659 658 657 -1224 10 680 658 657 -1225 11 680 658 659 -1226 12 657 662 663 -1227 13 657 662 669 -1228 13 657 662 670 -1229 14 663 662 669 -1230 14 663 662 670 -1231 15 670 662 669 -1232 41 664 663 662 -1233 14 662 663 671 -1234 14 662 663 672 -1235 14 664 663 671 -1236 14 664 663 672 -1237 15 672 663 671 -1238 87 665 664 663 -1239 14 663 664 673 -1240 14 663 664 674 -1241 88 665 664 673 -1242 88 665 664 674 -1243 15 674 664 673 -1244 89 664 665 666 -1245 90 664 665 675 -1246 91 675 665 666 -1247 92 667 666 665 -1248 92 668 666 665 -1249 92 668 666 667 -1250 91 676 667 666 -1251 91 677 667 666 -1252 93 677 667 676 -1253 91 678 668 666 -1254 91 679 668 666 -1255 93 679 668 678 -1256 20 658 680 681 -1257 21 658 680 684 -1258 22 684 680 681 -1259 23 680 681 682 -1260 24 680 681 685 -1261 25 680 681 686 -1262 6 682 681 685 -1263 7 682 681 686 -1264 8 685 681 686 -1265 9 683 682 681 -1266 10 699 682 681 -1267 11 699 682 683 -1268 50 687 686 681 -1269 13 681 686 690 -1270 13 681 686 691 -1271 13 687 686 690 -1272 13 687 686 691 -1273 15 691 686 690 -1274 35 688 687 686 -1275 35 689 687 686 -1276 8 692 687 686 -1277 35 689 687 688 -1278 8 692 687 688 -1279 8 692 687 689 -1280 13 687 688 693 -1281 13 687 688 694 -1282 13 687 688 695 -1283 15 694 688 693 -1284 15 695 688 693 -1285 15 695 688 694 -1286 13 687 689 696 -1287 13 687 689 697 -1288 13 687 689 698 -1289 15 697 689 696 -1290 15 698 689 696 -1291 15 698 689 697 -1292 20 682 699 700 -1293 21 682 699 703 -1294 22 703 699 700 -1295 23 699 700 701 -1296 24 699 700 704 -1297 31 699 700 705 -1298 6 701 700 704 -1299 32 701 700 705 -1300 33 704 700 705 -1301 9 702 701 700 -1302 10 718 701 700 -1303 11 718 701 702 -1304 34 700 705 706 -1305 34 700 705 707 -1306 33 709 705 700 -1307 35 707 705 706 -1308 8 709 705 706 -1309 8 709 705 707 -1310 12 705 706 708 -1311 13 705 706 710 -1312 13 705 706 711 -1313 14 708 706 710 -1314 14 708 706 711 -1315 15 711 706 710 -1316 13 705 707 712 -1317 13 705 707 713 -1318 13 705 707 714 -1319 15 713 707 712 -1320 15 714 707 712 -1321 15 714 707 713 -1322 14 706 708 715 -1323 14 706 708 716 -1324 14 706 708 717 -1325 15 716 708 715 -1326 15 717 708 715 -1327 15 717 708 716 -1328 20 701 718 719 -1329 21 701 718 722 -1330 22 722 718 719 -1331 23 718 719 720 -1332 24 718 719 723 -1333 25 718 719 724 -1334 6 720 719 723 -1335 7 720 719 724 -1336 8 723 719 724 -1337 9 721 720 719 -1338 10 738 720 719 -1339 11 738 720 721 -1340 36 719 724 725 -1341 13 719 724 731 -1342 13 719 724 732 -1343 37 731 724 725 -1344 37 732 724 725 -1345 15 732 724 731 -1346 38 724 725 726 -1347 38 724 725 727 -1348 39 727 725 726 -1349 39 728 726 725 -1350 40 725 726 733 -1351 40 728 726 733 -1352 39 729 727 725 -1353 40 725 727 734 -1354 40 729 727 734 -1355 39 730 728 726 -1356 40 726 728 735 -1357 40 730 728 735 -1358 39 730 729 727 -1359 40 727 729 736 -1360 40 730 729 736 -1361 39 729 730 728 -1362 40 728 730 737 -1363 40 729 730 737 -1364 20 720 738 739 -1365 21 720 738 742 -1366 22 742 738 739 -1367 23 738 739 740 -1368 24 738 739 743 -1369 25 738 739 744 -1370 6 740 739 743 -1371 7 740 739 744 -1372 8 743 739 744 -1373 9 741 740 739 -1374 10 748 740 739 -1375 11 748 740 741 -1376 13 739 744 745 -1377 13 739 744 746 -1378 13 739 744 747 -1379 15 746 744 745 -1380 15 747 744 745 -1381 15 747 744 746 -1382 51 749 748 740 -1383 21 740 748 752 -1384 52 749 748 752 -1385 53 748 749 750 -1386 54 748 749 753 -1387 54 748 749 754 -1388 55 750 749 753 -1389 55 750 749 754 -1390 56 754 749 753 -1391 57 749 750 751 -1392 58 755 750 749 -1393 11 755 750 751 -1394 20 750 755 756 -1395 21 750 755 759 -1396 22 759 755 756 -1397 23 755 756 757 -1398 24 755 756 760 -1399 25 755 756 761 -1400 6 757 756 760 -1401 7 757 756 761 -1402 8 760 756 761 -1403 9 758 757 756 -1404 10 777 757 756 -1405 11 777 757 758 -1406 12 756 761 762 -1407 13 756 761 766 -1408 13 756 761 767 -1409 14 762 761 766 -1410 14 762 761 767 -1411 15 767 761 766 -1412 41 763 762 761 -1413 14 761 762 768 -1414 14 761 762 769 -1415 14 763 762 768 -1416 14 763 762 769 -1417 15 769 762 768 -1418 41 764 763 762 -1419 14 762 763 770 -1420 14 762 763 771 -1421 14 764 763 770 -1422 14 764 763 771 -1423 15 771 763 770 -1424 42 763 764 765 -1425 14 763 764 772 -1426 14 763 764 773 -1427 43 772 764 765 -1428 43 773 764 765 -1429 15 773 764 772 -1430 44 764 765 774 -1431 44 764 765 775 -1432 44 764 765 776 -1433 45 775 765 774 -1434 45 776 765 774 -1435 45 776 765 775 -1436 20 757 777 778 -1437 21 757 777 781 -1438 22 781 777 778 -1439 23 777 778 779 -1440 24 777 778 782 -1441 25 777 778 783 -1442 6 779 778 782 -1443 7 779 778 783 -1444 8 782 778 783 -1445 9 780 779 778 -1446 10 794 779 778 -1447 11 794 779 780 -1448 12 778 783 784 -1449 13 778 783 788 -1450 13 778 783 789 -1451 14 784 783 788 -1452 14 784 783 789 -1453 15 789 783 788 -1454 26 785 784 783 -1455 14 783 784 790 -1456 14 783 784 791 -1457 27 785 784 790 -1458 27 785 784 791 -1459 15 791 784 790 -1460 28 786 785 784 -1461 29 787 785 784 -1462 11 787 785 786 -1463 21 785 787 792 -1464 21 785 787 793 -1465 30 793 787 792 -1466 20 779 794 795 -1467 21 779 794 798 -1468 22 798 794 795 -1469 23 794 795 796 -1470 24 794 795 799 -1471 25 794 795 800 -1472 6 796 795 799 -1473 7 796 795 800 -1474 8 799 795 800 -1475 9 797 796 795 -1476 10 813 796 795 -1477 11 813 796 797 -1478 50 801 800 795 -1479 13 795 800 804 -1480 13 795 800 805 -1481 13 801 800 804 -1482 13 801 800 805 -1483 15 805 800 804 -1484 35 802 801 800 -1485 35 803 801 800 -1486 8 806 801 800 -1487 35 803 801 802 -1488 8 806 801 802 -1489 8 806 801 803 -1490 13 801 802 807 -1491 13 801 802 808 -1492 13 801 802 809 -1493 15 808 802 807 -1494 15 809 802 807 -1495 15 809 802 808 -1496 13 801 803 810 -1497 13 801 803 811 -1498 13 801 803 812 -1499 15 811 803 810 -1500 15 812 803 810 -1501 15 812 803 811 -1502 20 796 813 814 -1503 21 796 813 817 -1504 22 817 813 814 -1505 23 813 814 815 -1506 24 813 814 818 -1507 25 813 814 819 -1508 6 815 814 818 -1509 7 815 814 819 -1510 8 818 814 819 -1511 9 816 815 814 -1512 10 828 815 814 -1513 11 828 815 816 -1514 12 814 819 820 -1515 13 814 819 824 -1516 13 814 819 825 -1517 14 820 819 824 -1518 14 820 819 825 -1519 15 825 819 824 -1520 59 819 820 821 -1521 14 819 820 826 -1522 14 819 820 827 -1523 60 826 820 821 -1524 60 827 820 821 -1525 15 827 820 826 -1526 61 820 821 822 -1527 61 820 821 823 -1528 62 823 821 822 -1529 20 815 828 829 -1530 21 815 828 832 -1531 22 832 828 829 -1532 23 828 829 830 -1533 24 828 829 833 -1534 25 828 829 834 -1535 6 830 829 833 -1536 7 830 829 834 -1537 8 833 829 834 -1538 9 831 830 829 -1539 10 840 830 829 -1540 11 840 830 831 -1541 85 829 834 835 -1542 13 829 834 838 -1543 13 829 834 839 -1544 60 838 834 835 -1545 60 839 834 835 -1546 15 839 834 838 -1547 61 834 835 836 -1548 61 834 835 837 -1549 62 837 835 836 -1550 51 841 840 830 -1551 21 830 840 844 -1552 52 841 840 844 -1553 53 840 841 842 -1554 54 840 841 845 -1555 54 840 841 846 -1556 55 842 841 845 -1557 55 842 841 846 -1558 56 846 841 845 -1559 57 841 842 843 -1560 58 847 842 841 -1561 11 847 842 843 -1562 20 842 847 848 -1563 21 842 847 851 -1564 22 851 847 848 -1565 23 847 848 849 -1566 24 847 848 852 -1567 25 847 848 853 -1568 6 849 848 852 -1569 7 849 848 853 -1570 8 852 848 853 -1571 9 850 849 848 -1572 10 871 849 848 -1573 11 871 849 850 -1574 12 848 853 854 -1575 13 848 853 860 -1576 13 848 853 861 -1577 14 854 853 860 -1578 14 854 853 861 -1579 15 861 853 860 -1580 41 855 854 853 -1581 14 853 854 862 -1582 14 853 854 863 -1583 14 855 854 862 -1584 14 855 854 863 -1585 15 863 854 862 -1586 87 856 855 854 -1587 14 854 855 864 -1588 14 854 855 865 -1589 88 856 855 864 -1590 88 856 855 865 -1591 15 865 855 864 -1592 89 855 856 857 -1593 90 855 856 866 -1594 91 866 856 857 -1595 92 858 857 856 -1596 92 859 857 856 -1597 92 859 857 858 -1598 91 867 858 857 -1599 91 868 858 857 -1600 93 868 858 867 -1601 91 869 859 857 -1602 91 870 859 857 -1603 93 870 859 869 -1604 20 849 871 872 -1605 21 849 871 875 -1606 22 875 871 872 -1607 23 871 872 873 -1608 24 871 872 876 -1609 31 871 872 877 -1610 6 873 872 876 -1611 32 873 872 877 -1612 33 876 872 877 -1613 9 874 873 872 -1614 10 885 873 872 -1615 11 885 873 874 -1616 46 872 877 878 -1617 34 872 877 879 -1618 33 880 877 872 -1619 47 879 877 878 -1620 48 880 877 878 -1621 8 880 877 879 -1622 49 877 878 881 -1623 13 877 879 882 -1624 13 877 879 883 -1625 13 877 879 884 -1626 15 883 879 882 -1627 15 884 879 882 -1628 15 884 879 883 -1629 20 873 885 886 -1630 21 873 885 889 -1631 22 889 885 886 -1632 23 885 886 887 -1633 24 885 886 890 -1634 25 885 886 891 -1635 6 887 886 890 -1636 7 887 886 891 -1637 8 890 886 891 -1638 9 888 887 886 -1639 10 904 887 886 -1640 11 904 887 888 -1641 50 892 891 886 -1642 13 886 891 895 -1643 13 886 891 896 -1644 13 892 891 895 -1645 13 892 891 896 -1646 15 896 891 895 -1647 35 893 892 891 -1648 35 894 892 891 -1649 8 897 892 891 -1650 35 894 892 893 -1651 8 897 892 893 -1652 8 897 892 894 -1653 13 892 893 898 -1654 13 892 893 899 -1655 13 892 893 900 -1656 15 899 893 898 -1657 15 900 893 898 -1658 15 900 893 899 -1659 13 892 894 901 -1660 13 892 894 902 -1661 13 892 894 903 -1662 15 902 894 901 -1663 15 903 894 901 -1664 15 903 894 902 -1665 20 887 904 905 -1666 21 887 904 908 -1667 22 908 904 905 -1668 23 904 905 906 -1669 24 904 905 909 -1670 25 904 905 910 -1671 6 906 905 909 -1672 7 906 905 910 -1673 8 909 905 910 -1674 9 907 906 905 -1675 10 915 906 905 -1676 11 915 906 907 -1677 82 905 910 911 -1678 13 905 910 912 -1679 13 905 910 913 -1680 83 912 910 911 -1681 83 913 910 911 -1682 15 913 910 912 -1683 84 910 911 914 -1684 20 906 915 916 -1685 21 906 915 919 -1686 22 919 915 916 -1687 23 915 916 917 -1688 24 915 916 920 -1689 25 915 916 921 -1690 6 917 916 920 -1691 7 917 916 921 -1692 8 920 916 921 -1693 9 918 917 916 -1694 10 927 917 916 -1695 11 927 917 918 -1696 85 916 921 922 -1697 13 916 921 925 -1698 13 916 921 926 -1699 60 925 921 922 -1700 60 926 921 922 -1701 15 926 921 925 -1702 61 921 922 923 -1703 61 921 922 924 -1704 62 924 922 923 -1705 20 917 927 928 -1706 21 917 927 931 -1707 22 931 927 928 -1708 23 927 928 929 -1709 24 927 928 932 -1710 25 927 928 933 -1711 6 929 928 932 -1712 7 929 928 933 -1713 8 932 928 933 -1714 9 930 929 928 -1715 10 948 929 928 -1716 11 948 929 930 -1717 36 928 933 934 -1718 13 928 933 941 -1719 13 928 933 942 -1720 37 941 933 934 -1721 37 942 933 934 -1722 15 942 933 941 -1723 38 933 934 935 -1724 38 933 934 936 -1725 39 936 934 935 -1726 39 937 935 934 -1727 40 934 935 943 -1728 40 937 935 943 -1729 39 938 936 934 -1730 40 934 936 944 -1731 40 938 936 944 -1732 39 939 937 935 -1733 40 935 937 945 -1734 40 939 937 945 -1735 39 939 938 936 -1736 40 936 938 946 -1737 40 939 938 946 -1738 39 938 939 937 -1739 94 937 939 940 -1740 94 938 939 940 -1741 95 939 940 947 -1742 20 929 948 949 -1743 21 929 948 952 -1744 22 952 948 949 -1745 23 948 949 950 -1746 24 948 949 953 -1747 25 948 949 954 -1748 6 950 949 953 -1749 7 950 949 954 -1750 8 953 949 954 -1751 9 951 950 949 -1752 10 962 950 949 -1753 11 962 950 951 -1754 86 955 954 949 -1755 13 949 954 958 -1756 13 949 954 959 -1757 27 955 954 958 -1758 27 955 954 959 -1759 15 959 954 958 -1760 28 956 955 954 -1761 29 957 955 954 -1762 11 957 955 956 -1763 21 955 957 960 -1764 21 955 957 961 -1765 30 961 957 960 -1766 20 950 962 963 -1767 21 950 962 966 -1768 22 966 962 963 -1769 23 962 963 964 -1770 24 962 963 967 -1771 31 962 963 968 -1772 6 964 963 967 -1773 32 964 963 968 -1774 33 967 963 968 -1775 9 965 964 963 -1776 10 981 964 963 -1777 11 981 964 965 -1778 34 963 968 969 -1779 34 963 968 970 -1780 33 972 968 963 -1781 35 970 968 969 -1782 8 972 968 969 -1783 8 972 968 970 -1784 12 968 969 971 -1785 13 968 969 973 -1786 13 968 969 974 -1787 14 971 969 973 -1788 14 971 969 974 -1789 15 974 969 973 -1790 13 968 970 975 -1791 13 968 970 976 -1792 13 968 970 977 -1793 15 976 970 975 -1794 15 977 970 975 -1795 15 977 970 976 -1796 14 969 971 978 -1797 14 969 971 979 -1798 14 969 971 980 -1799 15 979 971 978 -1800 15 980 971 978 -1801 15 980 971 979 -1802 20 964 981 982 -1803 21 964 981 985 -1804 22 985 981 982 -1805 23 981 982 983 -1806 24 981 982 986 -1807 25 981 982 987 -1808 6 983 982 986 -1809 7 983 982 987 -1810 8 986 982 987 -1811 9 984 983 982 -1812 10 998 983 982 -1813 11 998 983 984 -1814 12 982 987 988 -1815 13 982 987 992 -1816 13 982 987 993 -1817 14 988 987 992 -1818 14 988 987 993 -1819 15 993 987 992 -1820 26 989 988 987 -1821 14 987 988 994 -1822 14 987 988 995 -1823 27 989 988 994 -1824 27 989 988 995 -1825 15 995 988 994 -1826 28 990 989 988 -1827 29 991 989 988 -1828 11 991 989 990 -1829 21 989 991 996 -1830 21 989 991 997 -1831 30 997 991 996 -1832 20 983 998 999 -1833 21 983 998 1002 -1834 22 1002 998 999 -1835 23 998 999 1000 -1836 24 998 999 1003 -1837 25 998 999 1004 -1838 6 1000 999 1003 -1839 7 1000 999 1004 -1840 8 1003 999 1004 -1841 9 1001 1000 999 -1842 10 1020 1000 999 -1843 11 1020 1000 1001 -1844 12 999 1004 1005 -1845 13 999 1004 1009 -1846 13 999 1004 1010 -1847 14 1005 1004 1009 -1848 14 1005 1004 1010 -1849 15 1010 1004 1009 -1850 41 1006 1005 1004 -1851 14 1004 1005 1011 -1852 14 1004 1005 1012 -1853 14 1006 1005 1011 -1854 14 1006 1005 1012 -1855 15 1012 1005 1011 -1856 41 1007 1006 1005 -1857 14 1005 1006 1013 -1858 14 1005 1006 1014 -1859 14 1007 1006 1013 -1860 14 1007 1006 1014 -1861 15 1014 1006 1013 -1862 42 1006 1007 1008 -1863 14 1006 1007 1015 -1864 14 1006 1007 1016 -1865 43 1015 1007 1008 -1866 43 1016 1007 1008 -1867 15 1016 1007 1015 -1868 44 1007 1008 1017 -1869 44 1007 1008 1018 -1870 44 1007 1008 1019 -1871 45 1018 1008 1017 -1872 45 1019 1008 1017 -1873 45 1019 1008 1018 -1874 20 1000 1020 1021 -1875 21 1000 1020 1024 -1876 22 1024 1020 1021 -1877 23 1020 1021 1022 -1878 24 1020 1021 1025 -1879 25 1020 1021 1026 -1880 6 1022 1021 1025 -1881 7 1022 1021 1026 -1882 8 1025 1021 1026 -1883 9 1023 1022 1021 -1884 10 1035 1022 1021 -1885 11 1035 1022 1023 -1886 12 1021 1026 1027 -1887 13 1021 1026 1031 -1888 13 1021 1026 1032 -1889 14 1027 1026 1031 -1890 14 1027 1026 1032 -1891 15 1032 1026 1031 -1892 59 1026 1027 1028 -1893 14 1026 1027 1033 -1894 14 1026 1027 1034 -1895 60 1033 1027 1028 -1896 60 1034 1027 1028 -1897 15 1034 1027 1033 -1898 61 1027 1028 1029 -1899 61 1027 1028 1030 -1900 62 1030 1028 1029 -1901 20 1022 1035 1036 -1902 21 1022 1035 1039 -1903 22 1039 1035 1036 -1904 23 1035 1036 1037 -1905 24 1035 1036 1040 -1906 25 1035 1036 1041 -1907 6 1037 1036 1040 -1908 7 1037 1036 1041 -1909 8 1040 1036 1041 -1910 9 1038 1037 1036 -1911 10 1046 1037 1036 -1912 11 1046 1037 1038 -1913 82 1036 1041 1042 -1914 13 1036 1041 1043 -1915 13 1036 1041 1044 -1916 83 1043 1041 1042 -1917 83 1044 1041 1042 -1918 15 1044 1041 1043 -1919 84 1041 1042 1045 -1920 20 1037 1046 1047 -1921 21 1037 1046 1050 -1922 22 1050 1046 1047 -1923 23 1046 1047 1048 -1924 24 1046 1047 1051 -1925 31 1046 1047 1052 -1926 6 1048 1047 1051 -1927 32 1048 1047 1052 -1928 33 1051 1047 1052 -1929 9 1049 1048 1047 -1930 10 1060 1048 1047 -1931 11 1060 1048 1049 -1932 46 1047 1052 1053 -1933 34 1047 1052 1054 -1934 33 1055 1052 1047 -1935 47 1054 1052 1053 -1936 48 1055 1052 1053 -1937 8 1055 1052 1054 -1938 49 1052 1053 1056 -1939 13 1052 1054 1057 -1940 13 1052 1054 1058 -1941 13 1052 1054 1059 -1942 15 1058 1054 1057 -1943 15 1059 1054 1057 -1944 15 1059 1054 1058 -1945 20 1048 1060 1061 -1946 21 1048 1060 1064 -1947 22 1064 1060 1061 -1948 23 1060 1061 1062 -1949 24 1060 1061 1065 -1950 25 1060 1061 1066 -1951 6 1062 1061 1065 -1952 7 1062 1061 1066 -1953 8 1065 1061 1066 -1954 9 1063 1062 1061 -1955 10 1079 1062 1061 -1956 11 1079 1062 1063 -1957 50 1067 1066 1061 -1958 13 1061 1066 1070 -1959 13 1061 1066 1071 -1960 13 1067 1066 1070 -1961 13 1067 1066 1071 -1962 15 1071 1066 1070 -1963 35 1068 1067 1066 -1964 35 1069 1067 1066 -1965 8 1072 1067 1066 -1966 35 1069 1067 1068 -1967 8 1072 1067 1068 -1968 8 1072 1067 1069 -1969 13 1067 1068 1073 -1970 13 1067 1068 1074 -1971 13 1067 1068 1075 -1972 15 1074 1068 1073 -1973 15 1075 1068 1073 -1974 15 1075 1068 1074 -1975 13 1067 1069 1076 -1976 13 1067 1069 1077 -1977 13 1067 1069 1078 -1978 15 1077 1069 1076 -1979 15 1078 1069 1076 -1980 15 1078 1069 1077 -1981 20 1062 1079 1080 -1982 21 1062 1079 1083 -1983 22 1083 1079 1080 -1984 23 1079 1080 1081 -1985 24 1079 1080 1084 -1986 25 1079 1080 1085 -1987 6 1081 1080 1084 -1988 7 1081 1080 1085 -1989 8 1084 1080 1085 -1990 9 1082 1081 1080 -1991 10 1097 1081 1080 -1992 11 1097 1081 1082 -1993 96 1080 1085 1086 -1994 13 1080 1085 1091 -1995 13 1080 1085 1092 -1996 97 1091 1085 1086 -1997 97 1092 1085 1086 -1998 15 1092 1085 1091 -1999 98 1085 1086 1087 -2000 99 1085 1086 1088 -2001 100 1087 1086 1088 -2002 101 1086 1087 1089 -2003 102 1093 1087 1086 -2004 103 1093 1087 1089 -2005 100 1090 1088 1086 -2006 104 1086 1088 1094 -2007 105 1090 1088 1094 -2008 106 1090 1089 1087 -2009 107 1087 1089 1095 -2010 107 1090 1089 1095 -2011 101 1088 1090 1089 -2012 102 1096 1090 1088 -2013 103 1096 1090 1089 -2014 20 1081 1097 1098 -2015 21 1081 1097 1101 -2016 22 1101 1097 1098 -2017 23 1097 1098 1099 -2018 24 1097 1098 1102 -2019 25 1097 1098 1103 -2020 6 1099 1098 1102 -2021 7 1099 1098 1103 -2022 8 1102 1098 1103 -2023 9 1100 1099 1098 -2024 10 1116 1099 1098 -2025 11 1116 1099 1100 -2026 50 1104 1103 1098 -2027 13 1098 1103 1107 -2028 13 1098 1103 1108 -2029 13 1104 1103 1107 -2030 13 1104 1103 1108 -2031 15 1108 1103 1107 -2032 35 1105 1104 1103 -2033 35 1106 1104 1103 -2034 8 1109 1104 1103 -2035 35 1106 1104 1105 -2036 8 1109 1104 1105 -2037 8 1109 1104 1106 -2038 13 1104 1105 1110 -2039 13 1104 1105 1111 -2040 13 1104 1105 1112 -2041 15 1111 1105 1110 -2042 15 1112 1105 1110 -2043 15 1112 1105 1111 -2044 13 1104 1106 1113 -2045 13 1104 1106 1114 -2046 13 1104 1106 1115 -2047 15 1114 1106 1113 -2048 15 1115 1106 1113 -2049 15 1115 1106 1114 -2050 20 1099 1116 1117 -2051 21 1099 1116 1120 -2052 22 1120 1116 1117 -2053 23 1116 1117 1118 -2054 24 1116 1117 1121 -2055 31 1116 1117 1122 -2056 6 1118 1117 1121 -2057 32 1118 1117 1122 -2058 33 1121 1117 1122 -2059 9 1119 1118 1117 -2060 10 1132 1118 1117 -2061 11 1132 1118 1119 -2062 34 1117 1122 1123 -2063 34 1117 1122 1124 -2064 33 1125 1122 1117 -2065 35 1124 1122 1123 -2066 8 1125 1122 1123 -2067 8 1125 1122 1124 -2068 13 1122 1123 1126 -2069 13 1122 1123 1127 -2070 13 1122 1123 1128 -2071 15 1127 1123 1126 -2072 15 1128 1123 1126 -2073 15 1128 1123 1127 -2074 13 1122 1124 1129 -2075 13 1122 1124 1130 -2076 13 1122 1124 1131 -2077 15 1130 1124 1129 -2078 15 1131 1124 1129 -2079 15 1131 1124 1130 -2080 20 1118 1132 1133 -2081 21 1118 1132 1136 -2082 22 1136 1132 1133 -2083 23 1132 1133 1134 -2084 24 1132 1133 1137 -2085 25 1132 1133 1138 -2086 6 1134 1133 1137 -2087 7 1134 1133 1138 -2088 8 1137 1133 1138 -2089 9 1135 1134 1133 -2090 10 1151 1134 1133 -2091 11 1151 1134 1135 -2092 50 1139 1138 1133 -2093 13 1133 1138 1142 -2094 13 1133 1138 1143 -2095 13 1139 1138 1142 -2096 13 1139 1138 1143 -2097 15 1143 1138 1142 -2098 35 1140 1139 1138 -2099 35 1141 1139 1138 -2100 8 1144 1139 1138 -2101 35 1141 1139 1140 -2102 8 1144 1139 1140 -2103 8 1144 1139 1141 -2104 13 1139 1140 1145 -2105 13 1139 1140 1146 -2106 13 1139 1140 1147 -2107 15 1146 1140 1145 -2108 15 1147 1140 1145 -2109 15 1147 1140 1146 -2110 13 1139 1141 1148 -2111 13 1139 1141 1149 -2112 13 1139 1141 1150 -2113 15 1149 1141 1148 -2114 15 1150 1141 1148 -2115 15 1150 1141 1149 -2116 20 1134 1151 1152 -2117 21 1134 1151 1155 -2118 22 1155 1151 1152 -2119 23 1151 1152 1153 -2120 24 1151 1152 1156 -2121 25 1151 1152 1157 -2122 6 1153 1152 1156 -2123 7 1153 1152 1157 -2124 8 1156 1152 1157 -2125 9 1154 1153 1152 -2126 10 1175 1153 1152 -2127 11 1175 1153 1154 -2128 12 1152 1157 1158 -2129 13 1152 1157 1164 -2130 13 1152 1157 1165 -2131 14 1158 1157 1164 -2132 14 1158 1157 1165 -2133 15 1165 1157 1164 -2134 41 1159 1158 1157 -2135 14 1157 1158 1166 -2136 14 1157 1158 1167 -2137 14 1159 1158 1166 -2138 14 1159 1158 1167 -2139 15 1167 1158 1166 -2140 87 1160 1159 1158 -2141 14 1158 1159 1168 -2142 14 1158 1159 1169 -2143 88 1160 1159 1168 -2144 88 1160 1159 1169 -2145 15 1169 1159 1168 -2146 89 1159 1160 1161 -2147 90 1159 1160 1170 -2148 91 1170 1160 1161 -2149 92 1162 1161 1160 -2150 92 1163 1161 1160 -2151 92 1163 1161 1162 -2152 91 1171 1162 1161 -2153 91 1172 1162 1161 -2154 93 1172 1162 1171 -2155 91 1173 1163 1161 -2156 91 1174 1163 1161 -2157 93 1174 1163 1173 -2158 20 1153 1175 1176 -2159 21 1153 1175 1179 -2160 22 1179 1175 1176 -2161 23 1175 1176 1177 -2162 24 1175 1176 1180 -2163 25 1175 1176 1181 -2164 6 1177 1176 1180 -2165 7 1177 1176 1181 -2166 8 1180 1176 1181 -2167 9 1178 1177 1176 -2168 10 1194 1177 1176 -2169 11 1194 1177 1178 -2170 50 1182 1181 1176 -2171 13 1176 1181 1185 -2172 13 1176 1181 1186 -2173 13 1182 1181 1185 -2174 13 1182 1181 1186 -2175 15 1186 1181 1185 -2176 35 1183 1182 1181 -2177 35 1184 1182 1181 -2178 8 1187 1182 1181 -2179 35 1184 1182 1183 -2180 8 1187 1182 1183 -2181 8 1187 1182 1184 -2182 13 1182 1183 1188 -2183 13 1182 1183 1189 -2184 13 1182 1183 1190 -2185 15 1189 1183 1188 -2186 15 1190 1183 1188 -2187 15 1190 1183 1189 -2188 13 1182 1184 1191 -2189 13 1182 1184 1192 -2190 13 1182 1184 1193 -2191 15 1192 1184 1191 -2192 15 1193 1184 1191 -2193 15 1193 1184 1192 -2194 20 1177 1194 1195 -2195 21 1177 1194 1198 -2196 22 1198 1194 1195 -2197 23 1194 1195 1196 -2198 24 1194 1195 1199 -2199 25 1194 1195 1200 -2200 6 1196 1195 1199 -2201 7 1196 1195 1200 -2202 8 1199 1195 1200 -2203 9 1197 1196 1195 -2204 10 1218 1196 1195 -2205 11 1218 1196 1197 -2206 12 1195 1200 1201 -2207 13 1195 1200 1207 -2208 13 1195 1200 1208 -2209 14 1201 1200 1207 -2210 14 1201 1200 1208 -2211 15 1208 1200 1207 -2212 41 1202 1201 1200 -2213 14 1200 1201 1209 -2214 14 1200 1201 1210 -2215 14 1202 1201 1209 -2216 14 1202 1201 1210 -2217 15 1210 1201 1209 -2218 87 1203 1202 1201 -2219 14 1201 1202 1211 -2220 14 1201 1202 1212 -2221 88 1203 1202 1211 -2222 88 1203 1202 1212 -2223 15 1212 1202 1211 -2224 89 1202 1203 1204 -2225 90 1202 1203 1213 -2226 91 1213 1203 1204 -2227 92 1205 1204 1203 -2228 92 1206 1204 1203 -2229 92 1206 1204 1205 -2230 91 1214 1205 1204 -2231 91 1215 1205 1204 -2232 93 1215 1205 1214 -2233 91 1216 1206 1204 -2234 91 1217 1206 1204 -2235 93 1217 1206 1216 -2236 51 1219 1218 1196 -2237 21 1196 1218 1222 -2238 52 1219 1218 1222 -2239 53 1218 1219 1220 -2240 54 1218 1219 1223 -2241 54 1218 1219 1224 -2242 55 1220 1219 1223 -2243 55 1220 1219 1224 -2244 56 1224 1219 1223 -2245 57 1219 1220 1221 -2246 58 1225 1220 1219 -2247 11 1225 1220 1221 -2248 51 1226 1225 1220 -2249 21 1220 1225 1229 -2250 52 1226 1225 1229 -2251 108 1225 1226 1227 -2252 54 1225 1226 1230 -2253 54 1225 1226 1231 -2254 109 1230 1226 1227 -2255 109 1231 1226 1227 -2256 56 1231 1226 1230 -2257 110 1226 1227 1228 -2258 110 1226 1227 1232 -2259 62 1232 1227 1228 -2260 111 1235 1233 1234 -2261 111 1238 1236 1237 -2262 111 1241 1239 1240 -2263 111 1244 1242 1243 -2264 111 1247 1245 1246 -2265 111 1250 1248 1249 -2266 111 1253 1251 1252 -2267 111 1256 1254 1255 -2268 111 1259 1257 1258 -2269 111 1262 1260 1261 -2270 111 1265 1263 1264 -2271 111 1268 1266 1267 -2272 111 1271 1269 1270 -2273 111 1274 1272 1273 -2274 111 1277 1275 1276 -2275 111 1280 1278 1279 -2276 111 1283 1281 1282 -2277 111 1286 1284 1285 -2278 111 1289 1287 1288 -2279 111 1292 1290 1291 -2280 111 1295 1293 1294 -2281 111 1298 1296 1297 -2282 111 1301 1299 1300 -2283 111 1304 1302 1303 -2284 111 1307 1305 1306 -2285 111 1310 1308 1309 -2286 111 1313 1311 1312 -2287 111 1316 1314 1315 -2288 111 1319 1317 1318 -2289 111 1322 1320 1321 -2290 111 1325 1323 1324 -2291 111 1328 1326 1327 -2292 111 1331 1329 1330 -2293 111 1334 1332 1333 -2294 111 1337 1335 1336 -2295 111 1340 1338 1339 -2296 111 1343 1341 1342 -2297 111 1346 1344 1345 -2298 111 1349 1347 1348 -2299 111 1352 1350 1351 -2300 111 1355 1353 1354 -2301 111 1358 1356 1357 -2302 111 1361 1359 1360 -2303 111 1364 1362 1363 -2304 111 1367 1365 1366 -2305 111 1370 1368 1369 -2306 111 1373 1371 1372 -2307 111 1376 1374 1375 -2308 111 1379 1377 1378 -2309 111 1382 1380 1381 -2310 111 1385 1383 1384 -2311 111 1388 1386 1387 -2312 111 1391 1389 1390 -2313 111 1394 1392 1393 -2314 111 1397 1395 1396 -2315 111 1400 1398 1399 -2316 111 1403 1401 1402 -2317 111 1406 1404 1405 -2318 111 1409 1407 1408 -2319 111 1412 1410 1411 -2320 111 1415 1413 1414 -2321 111 1418 1416 1417 -2322 111 1421 1419 1420 -2323 111 1424 1422 1423 -2324 111 1427 1425 1426 -2325 111 1430 1428 1429 -2326 111 1433 1431 1432 -2327 111 1436 1434 1435 -2328 111 1439 1437 1438 -2329 111 1442 1440 1441 -2330 111 1445 1443 1444 -2331 111 1448 1446 1447 -2332 111 1451 1449 1450 -2333 111 1454 1452 1453 -2334 111 1457 1455 1456 -2335 111 1460 1458 1459 -2336 111 1463 1461 1462 -2337 111 1466 1464 1465 -2338 111 1469 1467 1468 -2339 111 1472 1470 1471 -2340 111 1475 1473 1474 -2341 111 1478 1476 1477 -2342 111 1481 1479 1480 -2343 111 1484 1482 1483 -2344 111 1487 1485 1486 -2345 111 1490 1488 1489 -2346 111 1493 1491 1492 -2347 111 1496 1494 1495 -2348 111 1499 1497 1498 -2349 111 1502 1500 1501 -2350 111 1505 1503 1504 -2351 111 1508 1506 1507 -2352 111 1511 1509 1510 -2353 111 1514 1512 1513 -2354 111 1517 1515 1516 -2355 111 1520 1518 1519 -2356 111 1523 1521 1522 -2357 111 1526 1524 1525 -2358 111 1529 1527 1528 -2359 111 1532 1530 1531 -2360 111 1535 1533 1534 -2361 111 1538 1536 1537 -2362 111 1541 1539 1540 -2363 111 1544 1542 1543 -2364 111 1547 1545 1546 -2365 111 1550 1548 1549 -2366 111 1553 1551 1552 -2367 111 1556 1554 1555 -2368 111 1559 1557 1558 -2369 111 1562 1560 1561 -2370 111 1565 1563 1564 -2371 111 1568 1566 1567 -2372 111 1571 1569 1570 -2373 111 1574 1572 1573 -2374 111 1577 1575 1576 -2375 111 1580 1578 1579 -2376 111 1583 1581 1582 -2377 111 1586 1584 1585 -2378 111 1589 1587 1588 -2379 111 1592 1590 1591 -2380 111 1595 1593 1594 -2381 111 1598 1596 1597 -2382 111 1601 1599 1600 -2383 111 1604 1602 1603 -2384 111 1607 1605 1606 -2385 111 1610 1608 1609 -2386 111 1613 1611 1612 -2387 111 1616 1614 1615 -2388 111 1619 1617 1618 -2389 111 1622 1620 1621 -2390 111 1625 1623 1624 -2391 111 1628 1626 1627 -2392 111 1631 1629 1630 -2393 111 1634 1632 1633 -2394 111 1637 1635 1636 -2395 111 1640 1638 1639 -2396 111 1643 1641 1642 -2397 111 1646 1644 1645 -2398 111 1649 1647 1648 -2399 111 1652 1650 1651 -2400 111 1655 1653 1654 -2401 111 1658 1656 1657 -2402 111 1661 1659 1660 -2403 111 1664 1662 1663 -2404 111 1667 1665 1666 -2405 111 1670 1668 1669 -2406 111 1673 1671 1672 -2407 111 1676 1674 1675 -2408 111 1679 1677 1678 -2409 111 1682 1680 1681 -2410 111 1685 1683 1684 -2411 111 1688 1686 1687 -2412 111 1691 1689 1690 -2413 111 1694 1692 1693 -2414 111 1697 1695 1696 -2415 111 1700 1698 1699 -2416 111 1703 1701 1702 -2417 111 1706 1704 1705 -2418 111 1709 1707 1708 -2419 111 1712 1710 1711 -2420 111 1715 1713 1714 -2421 111 1718 1716 1717 -2422 111 1721 1719 1720 -2423 111 1724 1722 1723 -2424 111 1727 1725 1726 -2425 111 1730 1728 1729 -2426 111 1733 1731 1732 -2427 111 1736 1734 1735 -2428 111 1739 1737 1738 -2429 111 1742 1740 1741 -2430 111 1745 1743 1744 -2431 111 1748 1746 1747 -2432 111 1751 1749 1750 -2433 111 1754 1752 1753 -2434 111 1757 1755 1756 -2435 111 1760 1758 1759 -2436 111 1763 1761 1762 -2437 111 1766 1764 1765 -2438 111 1769 1767 1768 -2439 111 1772 1770 1771 -2440 111 1775 1773 1774 -2441 111 1778 1776 1777 -2442 111 1781 1779 1780 -2443 111 1784 1782 1783 -2444 111 1787 1785 1786 -2445 111 1790 1788 1789 -2446 111 1793 1791 1792 -2447 111 1796 1794 1795 -2448 111 1799 1797 1798 -2449 111 1802 1800 1801 -2450 111 1805 1803 1804 -2451 111 1808 1806 1807 -2452 111 1811 1809 1810 -2453 111 1814 1812 1813 -2454 111 1817 1815 1816 -2455 111 1820 1818 1819 -2456 111 1823 1821 1822 -2457 111 1826 1824 1825 -2458 111 1829 1827 1828 -2459 111 1832 1830 1831 -2460 111 1835 1833 1834 -2461 111 1838 1836 1837 -2462 111 1841 1839 1840 -2463 111 1844 1842 1843 -2464 111 1847 1845 1846 -2465 111 1850 1848 1849 -2466 111 1853 1851 1852 -2467 111 1856 1854 1855 -2468 111 1859 1857 1858 -2469 111 1862 1860 1861 -2470 111 1865 1863 1864 -2471 111 1868 1866 1867 -2472 111 1871 1869 1870 -2473 111 1874 1872 1873 -2474 111 1877 1875 1876 -2475 111 1880 1878 1879 -2476 111 1883 1881 1882 -2477 111 1886 1884 1885 -2478 111 1889 1887 1888 -2479 111 1892 1890 1891 -2480 111 1895 1893 1894 -2481 111 1898 1896 1897 -2482 111 1901 1899 1900 -2483 111 1904 1902 1903 -2484 111 1907 1905 1906 -2485 111 1910 1908 1909 -2486 111 1913 1911 1912 -2487 111 1916 1914 1915 -2488 111 1919 1917 1918 -2489 111 1922 1920 1921 -2490 111 1925 1923 1924 -2491 111 1928 1926 1927 -2492 111 1931 1929 1930 -2493 111 1934 1932 1933 -2494 111 1937 1935 1936 -2495 111 1940 1938 1939 -2496 111 1943 1941 1942 -2497 111 1946 1944 1945 -2498 111 1949 1947 1948 -2499 111 1952 1950 1951 -2500 111 1955 1953 1954 -2501 111 1958 1956 1957 -2502 111 1961 1959 1960 -2503 111 1964 1962 1963 -2504 111 1967 1965 1966 -2505 111 1970 1968 1969 -2506 111 1973 1971 1972 -2507 111 1976 1974 1975 -2508 111 1979 1977 1978 -2509 111 1982 1980 1981 -2510 111 1985 1983 1984 -2511 111 1988 1986 1987 -2512 111 1991 1989 1990 -2513 111 1994 1992 1993 -2514 111 1997 1995 1996 -2515 111 2000 1998 1999 -2516 111 2003 2001 2002 -2517 111 2006 2004 2005 -2518 111 2009 2007 2008 -2519 111 2012 2010 2011 -2520 111 2015 2013 2014 -2521 111 2018 2016 2017 -2522 111 2021 2019 2020 -2523 111 2024 2022 2023 -2524 111 2027 2025 2026 -2525 111 2030 2028 2029 -2526 111 2033 2031 2032 -2527 111 2036 2034 2035 -2528 111 2039 2037 2038 -2529 111 2042 2040 2041 -2530 111 2045 2043 2044 -2531 111 2048 2046 2047 -2532 111 2051 2049 2050 -2533 111 2054 2052 2053 -2534 111 2057 2055 2056 -2535 111 2060 2058 2059 -2536 111 2063 2061 2062 -2537 111 2066 2064 2065 -2538 111 2069 2067 2068 -2539 111 2072 2070 2071 -2540 111 2075 2073 2074 -2541 111 2078 2076 2077 -2542 111 2081 2079 2080 -2543 111 2084 2082 2083 -2544 111 2087 2085 2086 -2545 111 2090 2088 2089 -2546 111 2093 2091 2092 -2547 111 2096 2094 2095 -2548 111 2099 2097 2098 -2549 111 2102 2100 2101 -2550 111 2105 2103 2104 -2551 111 2108 2106 2107 -2552 111 2111 2109 2110 -2553 111 2114 2112 2113 -2554 111 2117 2115 2116 -2555 111 2120 2118 2119 -2556 111 2123 2121 2122 -2557 111 2126 2124 2125 -2558 111 2129 2127 2128 -2559 111 2132 2130 2131 -2560 111 2135 2133 2134 -2561 111 2138 2136 2137 -2562 111 2141 2139 2140 -2563 111 2144 2142 2143 -2564 111 2147 2145 2146 -2565 111 2150 2148 2149 -2566 111 2153 2151 2152 -2567 111 2156 2154 2155 -2568 111 2159 2157 2158 -2569 111 2162 2160 2161 -2570 111 2165 2163 2164 -2571 111 2168 2166 2167 -2572 111 2171 2169 2170 -2573 111 2174 2172 2173 -2574 111 2177 2175 2176 -2575 111 2180 2178 2179 -2576 111 2183 2181 2182 -2577 111 2186 2184 2185 -2578 111 2189 2187 2188 -2579 111 2192 2190 2191 -2580 111 2195 2193 2194 -2581 111 2198 2196 2197 -2582 111 2201 2199 2200 -2583 111 2204 2202 2203 -2584 111 2207 2205 2206 -2585 111 2210 2208 2209 -2586 111 2213 2211 2212 -2587 111 2216 2214 2215 -2588 111 2219 2217 2218 -2589 111 2222 2220 2221 -2590 111 2225 2223 2224 -2591 111 2228 2226 2227 -2592 111 2231 2229 2230 -2593 111 2234 2232 2233 -2594 111 2237 2235 2236 -2595 111 2240 2238 2239 -2596 111 2243 2241 2242 -2597 111 2246 2244 2245 -2598 111 2249 2247 2248 -2599 111 2252 2250 2251 -2600 111 2255 2253 2254 -2601 111 2258 2256 2257 -2602 111 2261 2259 2260 -2603 111 2264 2262 2263 -2604 111 2267 2265 2266 -2605 111 2270 2268 2269 -2606 111 2273 2271 2272 -2607 111 2276 2274 2275 -2608 111 2279 2277 2278 -2609 111 2282 2280 2281 -2610 111 2285 2283 2284 -2611 111 2288 2286 2287 -2612 111 2291 2289 2290 -2613 111 2294 2292 2293 -2614 111 2297 2295 2296 -2615 111 2300 2298 2299 -2616 111 2303 2301 2302 -2617 111 2306 2304 2305 -2618 111 2309 2307 2308 -2619 111 2312 2310 2311 -2620 111 2315 2313 2314 -2621 111 2318 2316 2317 -2622 111 2321 2319 2320 -2623 111 2324 2322 2323 -2624 111 2327 2325 2326 -2625 111 2330 2328 2329 -2626 111 2333 2331 2332 -2627 111 2336 2334 2335 -2628 111 2339 2337 2338 -2629 111 2342 2340 2341 -2630 111 2345 2343 2344 -2631 111 2348 2346 2347 -2632 111 2351 2349 2350 -2633 111 2354 2352 2353 -2634 111 2357 2355 2356 -2635 111 2360 2358 2359 -2636 111 2363 2361 2362 -2637 111 2366 2364 2365 -2638 111 2369 2367 2368 -2639 111 2372 2370 2371 -2640 111 2375 2373 2374 -2641 111 2378 2376 2377 -2642 111 2381 2379 2380 -2643 111 2384 2382 2383 -2644 111 2387 2385 2386 -2645 111 2390 2388 2389 -2646 111 2393 2391 2392 -2647 111 2396 2394 2395 -2648 111 2399 2397 2398 -2649 111 2402 2400 2401 -2650 111 2405 2403 2404 -2651 111 2408 2406 2407 -2652 111 2411 2409 2410 -2653 111 2414 2412 2413 -2654 111 2417 2415 2416 -2655 111 2420 2418 2419 -2656 111 2423 2421 2422 -2657 111 2426 2424 2425 -2658 111 2429 2427 2428 -2659 111 2432 2430 2431 -2660 111 2435 2433 2434 -2661 111 2438 2436 2437 -2662 111 2441 2439 2440 -2663 111 2444 2442 2443 -2664 111 2447 2445 2446 -2665 111 2450 2448 2449 -2666 111 2453 2451 2452 -2667 111 2456 2454 2455 -2668 111 2459 2457 2458 -2669 111 2462 2460 2461 -2670 111 2465 2463 2464 -2671 111 2468 2466 2467 -2672 111 2471 2469 2470 -2673 111 2474 2472 2473 -2674 111 2477 2475 2476 -2675 111 2480 2478 2479 -2676 111 2483 2481 2482 -2677 111 2486 2484 2485 -2678 111 2489 2487 2488 -2679 111 2492 2490 2491 -2680 111 2495 2493 2494 -2681 111 2498 2496 2497 -2682 111 2501 2499 2500 -2683 111 2504 2502 2503 -2684 111 2507 2505 2506 -2685 111 2510 2508 2509 -2686 111 2513 2511 2512 -2687 111 2516 2514 2515 -2688 111 2519 2517 2518 -2689 111 2522 2520 2521 -2690 111 2525 2523 2524 -2691 111 2528 2526 2527 -2692 111 2531 2529 2530 -2693 111 2534 2532 2533 -2694 111 2537 2535 2536 -2695 111 2540 2538 2539 -2696 111 2543 2541 2542 -2697 111 2546 2544 2545 -2698 111 2549 2547 2548 -2699 111 2552 2550 2551 -2700 111 2555 2553 2554 -2701 111 2558 2556 2557 -2702 111 2561 2559 2560 -2703 111 2564 2562 2563 -2704 111 2567 2565 2566 -2705 111 2570 2568 2569 -2706 111 2573 2571 2572 -2707 111 2576 2574 2575 -2708 111 2579 2577 2578 -2709 111 2582 2580 2581 -2710 111 2585 2583 2584 -2711 111 2588 2586 2587 -2712 111 2591 2589 2590 -2713 111 2594 2592 2593 -2714 111 2597 2595 2596 -2715 111 2600 2598 2599 -2716 111 2603 2601 2602 -2717 111 2606 2604 2605 -2718 111 2609 2607 2608 -2719 111 2612 2610 2611 -2720 111 2615 2613 2614 -2721 111 2618 2616 2617 -2722 111 2621 2619 2620 -2723 111 2624 2622 2623 -2724 111 2627 2625 2626 -2725 111 2630 2628 2629 -2726 111 2633 2631 2632 -2727 111 2636 2634 2635 -2728 111 2639 2637 2638 -2729 111 2642 2640 2641 -2730 111 2645 2643 2644 -2731 111 2648 2646 2647 -2732 111 2651 2649 2650 -2733 111 2654 2652 2653 -2734 111 2657 2655 2656 -2735 111 2660 2658 2659 -2736 111 2663 2661 2662 -2737 111 2666 2664 2665 -2738 111 2669 2667 2668 -2739 111 2672 2670 2671 -2740 111 2675 2673 2674 -2741 111 2678 2676 2677 -2742 111 2681 2679 2680 -2743 111 2684 2682 2683 -2744 111 2687 2685 2686 -2745 111 2690 2688 2689 -2746 111 2693 2691 2692 -2747 111 2696 2694 2695 -2748 111 2699 2697 2698 -2749 111 2702 2700 2701 -2750 111 2705 2703 2704 -2751 111 2708 2706 2707 -2752 111 2711 2709 2710 -2753 111 2714 2712 2713 -2754 111 2717 2715 2716 -2755 111 2720 2718 2719 -2756 111 2723 2721 2722 -2757 111 2726 2724 2725 -2758 111 2729 2727 2728 -2759 111 2732 2730 2731 -2760 111 2735 2733 2734 -2761 111 2738 2736 2737 -2762 111 2741 2739 2740 -2763 111 2744 2742 2743 -2764 111 2747 2745 2746 -2765 111 2750 2748 2749 -2766 111 2753 2751 2752 -2767 111 2756 2754 2755 -2768 111 2759 2757 2758 -2769 111 2762 2760 2761 -2770 111 2765 2763 2764 -2771 111 2768 2766 2767 -2772 111 2771 2769 2770 -2773 111 2774 2772 2773 -2774 111 2777 2775 2776 -2775 111 2780 2778 2779 -2776 111 2783 2781 2782 -2777 111 2786 2784 2785 -2778 111 2789 2787 2788 -2779 111 2792 2790 2791 -2780 111 2795 2793 2794 -2781 111 2798 2796 2797 -2782 111 2801 2799 2800 -2783 111 2804 2802 2803 -2784 111 2807 2805 2806 -2785 111 2810 2808 2809 -2786 111 2813 2811 2812 -2787 111 2816 2814 2815 -2788 111 2819 2817 2818 -2789 111 2822 2820 2821 -2790 111 2825 2823 2824 -2791 111 2828 2826 2827 -2792 111 2831 2829 2830 -2793 111 2834 2832 2833 -2794 111 2837 2835 2836 -2795 111 2840 2838 2839 -2796 111 2843 2841 2842 -2797 111 2846 2844 2845 -2798 111 2849 2847 2848 -2799 111 2852 2850 2851 -2800 111 2855 2853 2854 -2801 111 2858 2856 2857 -2802 111 2861 2859 2860 -2803 111 2864 2862 2863 -2804 111 2867 2865 2866 -2805 111 2870 2868 2869 -2806 111 2873 2871 2872 -2807 111 2876 2874 2875 -2808 111 2879 2877 2878 -2809 111 2882 2880 2881 -2810 111 2885 2883 2884 -2811 111 2888 2886 2887 -2812 111 2891 2889 2890 -2813 111 2894 2892 2893 -2814 111 2897 2895 2896 -2815 111 2900 2898 2899 -2816 111 2903 2901 2902 -2817 111 2906 2904 2905 -2818 111 2909 2907 2908 -2819 111 2912 2910 2911 -2820 111 2915 2913 2914 -2821 111 2918 2916 2917 -2822 111 2921 2919 2920 -2823 111 2924 2922 2923 -2824 111 2927 2925 2926 -2825 111 2930 2928 2929 -2826 111 2933 2931 2932 -2827 111 2936 2934 2935 -2828 111 2939 2937 2938 -2829 111 2942 2940 2941 -2830 111 2945 2943 2944 -2831 111 2948 2946 2947 -2832 111 2951 2949 2950 -2833 111 2954 2952 2953 -2834 111 2957 2955 2956 -2835 111 2960 2958 2959 -2836 111 2963 2961 2962 -2837 111 2966 2964 2965 -2838 111 2969 2967 2968 -2839 111 2972 2970 2971 -2840 111 2975 2973 2974 -2841 111 2978 2976 2977 -2842 111 2981 2979 2980 -2843 111 2984 2982 2983 -2844 111 2987 2985 2986 -2845 111 2990 2988 2989 -2846 111 2993 2991 2992 -2847 111 2996 2994 2995 -2848 111 2999 2997 2998 -2849 111 3002 3000 3001 -2850 111 3005 3003 3004 -2851 111 3008 3006 3007 -2852 111 3011 3009 3010 -2853 111 3014 3012 3013 -2854 111 3017 3015 3016 -2855 111 3020 3018 3019 -2856 111 3023 3021 3022 -2857 111 3026 3024 3025 -2858 111 3029 3027 3028 -2859 111 3032 3030 3031 -2860 111 3035 3033 3034 -2861 111 3038 3036 3037 -2862 111 3041 3039 3040 -2863 111 3044 3042 3043 -2864 111 3047 3045 3046 -2865 111 3050 3048 3049 -2866 111 3053 3051 3052 -2867 111 3056 3054 3055 -2868 111 3059 3057 3058 -2869 111 3062 3060 3061 -2870 111 3065 3063 3064 -2871 111 3068 3066 3067 -2872 111 3071 3069 3070 -2873 111 3074 3072 3073 -2874 111 3077 3075 3076 -2875 111 3080 3078 3079 -2876 111 3083 3081 3082 -2877 111 3086 3084 3085 -2878 111 3089 3087 3088 -2879 111 3092 3090 3091 -2880 111 3095 3093 3094 -2881 111 3098 3096 3097 -2882 111 3101 3099 3100 -2883 111 3104 3102 3103 -2884 111 3107 3105 3106 -2885 111 3110 3108 3109 -2886 111 3113 3111 3112 -2887 111 3116 3114 3115 -2888 111 3119 3117 3118 -2889 111 3122 3120 3121 -2890 111 3125 3123 3124 -2891 111 3128 3126 3127 -2892 111 3131 3129 3130 -2893 111 3134 3132 3133 -2894 111 3137 3135 3136 -2895 111 3140 3138 3139 -2896 111 3143 3141 3142 -2897 111 3146 3144 3145 -2898 111 3149 3147 3148 -2899 111 3152 3150 3151 -2900 111 3155 3153 3154 -2901 111 3158 3156 3157 -2902 111 3161 3159 3160 -2903 111 3164 3162 3163 -2904 111 3167 3165 3166 -2905 111 3170 3168 3169 -2906 111 3173 3171 3172 -2907 111 3176 3174 3175 -2908 111 3179 3177 3178 -2909 111 3182 3180 3181 -2910 111 3185 3183 3184 -2911 111 3188 3186 3187 -2912 111 3191 3189 3190 -2913 111 3194 3192 3193 -2914 111 3197 3195 3196 -2915 111 3200 3198 3199 -2916 111 3203 3201 3202 -2917 111 3206 3204 3205 -2918 111 3209 3207 3208 -2919 111 3212 3210 3211 -2920 111 3215 3213 3214 -2921 111 3218 3216 3217 -2922 111 3221 3219 3220 -2923 111 3224 3222 3223 -2924 111 3227 3225 3226 -2925 111 3230 3228 3229 -2926 111 3233 3231 3232 -2927 111 3236 3234 3235 -2928 111 3239 3237 3238 -2929 111 3242 3240 3241 -2930 111 3245 3243 3244 -2931 111 3248 3246 3247 -2932 111 3251 3249 3250 -2933 111 3254 3252 3253 -2934 111 3257 3255 3256 -2935 111 3260 3258 3259 -2936 111 3263 3261 3262 -2937 111 3266 3264 3265 -2938 111 3269 3267 3268 -2939 111 3272 3270 3271 -2940 111 3275 3273 3274 -2941 111 3278 3276 3277 -2942 111 3281 3279 3280 -2943 111 3284 3282 3283 -2944 111 3287 3285 3286 -2945 111 3290 3288 3289 -2946 111 3293 3291 3292 -2947 111 3296 3294 3295 -2948 111 3299 3297 3298 -2949 111 3302 3300 3301 -2950 111 3305 3303 3304 -2951 111 3308 3306 3307 -2952 111 3311 3309 3310 -2953 111 3314 3312 3313 -2954 111 3317 3315 3316 -2955 111 3320 3318 3319 -2956 111 3323 3321 3322 -2957 111 3326 3324 3325 -2958 111 3329 3327 3328 -2959 111 3332 3330 3331 -2960 111 3335 3333 3334 -2961 111 3338 3336 3337 -2962 111 3341 3339 3340 -2963 111 3344 3342 3343 -2964 111 3347 3345 3346 -2965 111 3350 3348 3349 -2966 111 3353 3351 3352 -2967 111 3356 3354 3355 -2968 111 3359 3357 3358 -2969 111 3362 3360 3361 -2970 111 3365 3363 3364 -2971 111 3368 3366 3367 -2972 111 3371 3369 3370 -2973 111 3374 3372 3373 -2974 111 3377 3375 3376 -2975 111 3380 3378 3379 -2976 111 3383 3381 3382 -2977 111 3386 3384 3385 -2978 111 3389 3387 3388 -2979 111 3392 3390 3391 -2980 111 3395 3393 3394 -2981 111 3398 3396 3397 -2982 111 3401 3399 3400 -2983 111 3404 3402 3403 -2984 111 3407 3405 3406 -2985 111 3410 3408 3409 -2986 111 3413 3411 3412 -2987 111 3416 3414 3415 -2988 111 3419 3417 3418 -2989 111 3422 3420 3421 -2990 111 3425 3423 3424 -2991 111 3428 3426 3427 -2992 111 3431 3429 3430 -2993 111 3434 3432 3433 -2994 111 3437 3435 3436 -2995 111 3440 3438 3439 -2996 111 3443 3441 3442 -2997 111 3446 3444 3445 -2998 111 3449 3447 3448 -2999 111 3452 3450 3451 -3000 111 3455 3453 3454 -3001 111 3458 3456 3457 -3002 111 3461 3459 3460 -3003 111 3464 3462 3463 -3004 111 3467 3465 3466 -3005 111 3470 3468 3469 -3006 111 3473 3471 3472 -3007 111 3476 3474 3475 -3008 111 3479 3477 3478 -3009 111 3482 3480 3481 -3010 111 3485 3483 3484 -3011 111 3488 3486 3487 -3012 111 3491 3489 3490 -3013 111 3494 3492 3493 -3014 111 3497 3495 3496 -3015 111 3500 3498 3499 -3016 111 3503 3501 3502 -3017 111 3506 3504 3505 -3018 111 3509 3507 3508 -3019 111 3512 3510 3511 -3020 111 3515 3513 3514 -3021 111 3518 3516 3517 -3022 111 3521 3519 3520 -3023 111 3524 3522 3523 -3024 111 3527 3525 3526 -3025 111 3530 3528 3529 -3026 111 3533 3531 3532 -3027 111 3536 3534 3535 -3028 111 3539 3537 3538 -3029 111 3542 3540 3541 -3030 111 3545 3543 3544 -3031 111 3548 3546 3547 -3032 111 3551 3549 3550 -3033 111 3554 3552 3553 -3034 111 3557 3555 3556 -3035 111 3560 3558 3559 -3036 111 3563 3561 3562 -3037 111 3566 3564 3565 -3038 111 3569 3567 3568 -3039 111 3572 3570 3571 -3040 111 3575 3573 3574 -3041 111 3578 3576 3577 -3042 111 3581 3579 3580 -3043 111 3584 3582 3583 -3044 111 3587 3585 3586 -3045 111 3590 3588 3589 -3046 111 3593 3591 3592 -3047 111 3596 3594 3595 -3048 111 3599 3597 3598 -3049 111 3602 3600 3601 -3050 111 3605 3603 3604 -3051 111 3608 3606 3607 -3052 111 3611 3609 3610 -3053 111 3614 3612 3613 -3054 111 3617 3615 3616 -3055 111 3620 3618 3619 -3056 111 3623 3621 3622 -3057 111 3626 3624 3625 -3058 111 3629 3627 3628 -3059 111 3632 3630 3631 -3060 111 3635 3633 3634 -3061 111 3638 3636 3637 -3062 111 3641 3639 3640 -3063 111 3644 3642 3643 -3064 111 3647 3645 3646 -3065 111 3650 3648 3649 -3066 111 3653 3651 3652 -3067 111 3656 3654 3655 -3068 111 3659 3657 3658 -3069 111 3662 3660 3661 -3070 111 3665 3663 3664 -3071 111 3668 3666 3667 -3072 111 3671 3669 3670 -3073 111 3674 3672 3673 -3074 111 3677 3675 3676 -3075 111 3680 3678 3679 -3076 111 3683 3681 3682 -3077 111 3686 3684 3685 -3078 111 3689 3687 3688 -3079 111 3692 3690 3691 -3080 111 3695 3693 3694 -3081 111 3698 3696 3697 -3082 111 3701 3699 3700 -3083 111 3704 3702 3703 -3084 111 3707 3705 3706 -3085 111 3710 3708 3709 -3086 111 3713 3711 3712 -3087 111 3716 3714 3715 -3088 111 3719 3717 3718 -3089 111 3722 3720 3721 -3090 111 3725 3723 3724 -3091 111 3728 3726 3727 -3092 111 3731 3729 3730 -3093 111 3734 3732 3733 -3094 111 3737 3735 3736 -3095 111 3740 3738 3739 -3096 111 3743 3741 3742 -3097 111 3746 3744 3745 -3098 111 3749 3747 3748 -3099 111 3752 3750 3751 -3100 111 3755 3753 3754 -3101 111 3758 3756 3757 -3102 111 3761 3759 3760 -3103 111 3764 3762 3763 -3104 111 3767 3765 3766 -3105 111 3770 3768 3769 -3106 111 3773 3771 3772 -3107 111 3776 3774 3775 -3108 111 3779 3777 3778 -3109 111 3782 3780 3781 -3110 111 3785 3783 3784 -3111 111 3788 3786 3787 -3112 111 3791 3789 3790 -3113 111 3794 3792 3793 -3114 111 3797 3795 3796 -3115 111 3800 3798 3799 -3116 111 3803 3801 3802 -3117 111 3806 3804 3805 -3118 111 3809 3807 3808 -3119 111 3812 3810 3811 -3120 111 3815 3813 3814 -3121 111 3818 3816 3817 -3122 111 3821 3819 3820 -3123 111 3824 3822 3823 -3124 111 3827 3825 3826 -3125 111 3830 3828 3829 -3126 111 3833 3831 3832 -3127 111 3836 3834 3835 -3128 111 3839 3837 3838 -3129 111 3842 3840 3841 -3130 111 3845 3843 3844 -3131 111 3848 3846 3847 -3132 111 3851 3849 3850 -3133 111 3854 3852 3853 -3134 111 3857 3855 3856 -3135 111 3860 3858 3859 -3136 111 3863 3861 3862 -3137 111 3866 3864 3865 -3138 111 3869 3867 3868 -3139 111 3872 3870 3871 -3140 111 3875 3873 3874 -3141 111 3878 3876 3877 -3142 111 3881 3879 3880 -3143 111 3884 3882 3883 -3144 111 3887 3885 3886 -3145 111 3890 3888 3889 -3146 111 3893 3891 3892 -3147 111 3896 3894 3895 -3148 111 3899 3897 3898 -3149 111 3902 3900 3901 -3150 111 3905 3903 3904 -3151 111 3908 3906 3907 -3152 111 3911 3909 3910 -3153 111 3914 3912 3913 -3154 111 3917 3915 3916 -3155 111 3920 3918 3919 -3156 111 3923 3921 3922 -3157 111 3926 3924 3925 -3158 111 3929 3927 3928 -3159 111 3932 3930 3931 -3160 111 3935 3933 3934 -3161 111 3938 3936 3937 -3162 111 3941 3939 3940 -3163 111 3944 3942 3943 -3164 111 3947 3945 3946 -3165 111 3950 3948 3949 -3166 111 3953 3951 3952 -3167 111 3956 3954 3955 -3168 111 3959 3957 3958 -3169 111 3962 3960 3961 -3170 111 3965 3963 3964 -3171 111 3968 3966 3967 -3172 111 3971 3969 3970 -3173 111 3974 3972 3973 -3174 111 3977 3975 3976 -3175 111 3980 3978 3979 -3176 111 3983 3981 3982 -3177 111 3986 3984 3985 -3178 111 3989 3987 3988 -3179 111 3992 3990 3991 -3180 111 3995 3993 3994 -3181 111 3998 3996 3997 -3182 111 4001 3999 4000 -3183 111 4004 4002 4003 -3184 111 4007 4005 4006 -3185 111 4010 4008 4009 -3186 111 4013 4011 4012 -3187 111 4016 4014 4015 -3188 111 4019 4017 4018 -3189 111 4022 4020 4021 -3190 111 4025 4023 4024 -3191 111 4028 4026 4027 -3192 111 4031 4029 4030 -3193 111 4034 4032 4033 -3194 111 4037 4035 4036 -3195 111 4040 4038 4039 -3196 111 4043 4041 4042 -3197 111 4046 4044 4045 -3198 111 4049 4047 4048 -3199 111 4052 4050 4051 -3200 111 4055 4053 4054 -3201 111 4058 4056 4057 -3202 111 4061 4059 4060 -3203 111 4064 4062 4063 -3204 111 4067 4065 4066 -3205 111 4070 4068 4069 -3206 111 4073 4071 4072 -3207 111 4076 4074 4075 -3208 111 4079 4077 4078 -3209 111 4082 4080 4081 -3210 111 4085 4083 4084 -3211 111 4088 4086 4087 -3212 111 4091 4089 4090 -3213 111 4094 4092 4093 -3214 111 4097 4095 4096 -3215 111 4100 4098 4099 -3216 111 4103 4101 4102 -3217 111 4106 4104 4105 -3218 111 4109 4107 4108 -3219 111 4112 4110 4111 -3220 111 4115 4113 4114 -3221 111 4118 4116 4117 -3222 111 4121 4119 4120 -3223 111 4124 4122 4123 -3224 111 4127 4125 4126 -3225 111 4130 4128 4129 -3226 111 4133 4131 4132 -3227 111 4136 4134 4135 -3228 111 4139 4137 4138 -3229 111 4142 4140 4141 -3230 111 4145 4143 4144 -3231 111 4148 4146 4147 -3232 111 4151 4149 4150 -3233 111 4154 4152 4153 -3234 111 4157 4155 4156 -3235 111 4160 4158 4159 -3236 111 4163 4161 4162 -3237 111 4166 4164 4165 -3238 111 4169 4167 4168 -3239 111 4172 4170 4171 -3240 111 4175 4173 4174 -3241 111 4178 4176 4177 -3242 111 4181 4179 4180 -3243 111 4184 4182 4183 -3244 111 4187 4185 4186 -3245 111 4190 4188 4189 -3246 111 4193 4191 4192 -3247 111 4196 4194 4195 -3248 111 4199 4197 4198 -3249 111 4202 4200 4201 -3250 111 4205 4203 4204 -3251 111 4208 4206 4207 -3252 111 4211 4209 4210 -3253 111 4214 4212 4213 -3254 111 4217 4215 4216 -3255 111 4220 4218 4219 -3256 111 4223 4221 4222 -3257 111 4226 4224 4225 -3258 111 4229 4227 4228 -3259 111 4232 4230 4231 -3260 111 4235 4233 4234 -3261 111 4238 4236 4237 -3262 111 4241 4239 4240 -3263 111 4244 4242 4243 -3264 111 4247 4245 4246 -3265 111 4250 4248 4249 -3266 111 4253 4251 4252 -3267 111 4256 4254 4255 -3268 111 4259 4257 4258 -3269 111 4262 4260 4261 -3270 111 4265 4263 4264 -3271 111 4268 4266 4267 -3272 111 4271 4269 4270 -3273 111 4274 4272 4273 -3274 111 4277 4275 4276 -3275 111 4280 4278 4279 -3276 111 4283 4281 4282 -3277 111 4286 4284 4285 -3278 111 4289 4287 4288 -3279 111 4292 4290 4291 -3280 111 4295 4293 4294 -3281 111 4298 4296 4297 -3282 111 4301 4299 4300 -3283 111 4304 4302 4303 -3284 111 4307 4305 4306 -3285 111 4310 4308 4309 -3286 111 4313 4311 4312 -3287 111 4316 4314 4315 -3288 111 4319 4317 4318 -3289 111 4322 4320 4321 -3290 111 4325 4323 4324 -3291 111 4328 4326 4327 -3292 111 4331 4329 4330 -3293 111 4334 4332 4333 -3294 111 4337 4335 4336 -3295 111 4340 4338 4339 -3296 111 4343 4341 4342 -3297 111 4346 4344 4345 -3298 111 4349 4347 4348 -3299 111 4352 4350 4351 -3300 111 4355 4353 4354 -3301 111 4358 4356 4357 -3302 111 4361 4359 4360 -3303 111 4364 4362 4363 -3304 111 4367 4365 4366 -3305 111 4370 4368 4369 -3306 111 4373 4371 4372 -3307 111 4376 4374 4375 -3308 111 4379 4377 4378 -3309 111 4382 4380 4381 -3310 111 4385 4383 4384 -3311 111 4388 4386 4387 -3312 111 4391 4389 4390 -3313 111 4394 4392 4393 -3314 111 4397 4395 4396 -3315 111 4400 4398 4399 -3316 111 4403 4401 4402 -3317 111 4406 4404 4405 -3318 111 4409 4407 4408 -3319 111 4412 4410 4411 -3320 111 4415 4413 4414 -3321 111 4418 4416 4417 -3322 111 4421 4419 4420 -3323 111 4424 4422 4423 -3324 111 4427 4425 4426 -3325 111 4430 4428 4429 -3326 111 4433 4431 4432 -3327 111 4436 4434 4435 -3328 111 4439 4437 4438 -3329 111 4442 4440 4441 -3330 111 4445 4443 4444 -3331 111 4448 4446 4447 -3332 111 4451 4449 4450 -3333 111 4454 4452 4453 -3334 111 4457 4455 4456 -3335 111 4460 4458 4459 -3336 111 4463 4461 4462 -3337 111 4466 4464 4465 -3338 111 4469 4467 4468 -3339 111 4472 4470 4471 -3340 111 4475 4473 4474 -3341 111 4478 4476 4477 -3342 111 4481 4479 4480 -3343 111 4484 4482 4483 -3344 111 4487 4485 4486 -3345 111 4490 4488 4489 -3346 111 4493 4491 4492 -3347 111 4496 4494 4495 -3348 111 4499 4497 4498 -3349 111 4502 4500 4501 -3350 111 4505 4503 4504 -3351 111 4508 4506 4507 -3352 111 4511 4509 4510 -3353 111 4514 4512 4513 -3354 111 4517 4515 4516 -3355 111 4520 4518 4519 -3356 111 4523 4521 4522 -3357 111 4526 4524 4525 -3358 111 4529 4527 4528 -3359 111 4532 4530 4531 -3360 111 4535 4533 4534 -3361 111 4538 4536 4537 -3362 111 4541 4539 4540 -3363 111 4544 4542 4543 -3364 111 4547 4545 4546 -3365 111 4550 4548 4549 -3366 111 4553 4551 4552 -3367 111 4556 4554 4555 -3368 111 4559 4557 4558 -3369 111 4562 4560 4561 -3370 111 4565 4563 4564 -3371 111 4568 4566 4567 -3372 111 4571 4569 4570 -3373 111 4574 4572 4573 -3374 111 4577 4575 4576 -3375 111 4580 4578 4579 -3376 111 4583 4581 4582 -3377 111 4586 4584 4585 -3378 111 4589 4587 4588 -3379 111 4592 4590 4591 -3380 111 4595 4593 4594 -3381 111 4598 4596 4597 -3382 111 4601 4599 4600 -3383 111 4604 4602 4603 -3384 111 4607 4605 4606 -3385 111 4610 4608 4609 -3386 111 4613 4611 4612 -3387 111 4616 4614 4615 -3388 111 4619 4617 4618 -3389 111 4622 4620 4621 -3390 111 4625 4623 4624 -3391 111 4628 4626 4627 -3392 111 4631 4629 4630 -3393 111 4634 4632 4633 -3394 111 4637 4635 4636 -3395 111 4640 4638 4639 -3396 111 4643 4641 4642 -3397 111 4646 4644 4645 -3398 111 4649 4647 4648 -3399 111 4652 4650 4651 -3400 111 4655 4653 4654 -3401 111 4658 4656 4657 -3402 111 4661 4659 4660 -3403 111 4664 4662 4663 -3404 111 4667 4665 4666 -3405 111 4670 4668 4669 -3406 111 4673 4671 4672 -3407 111 4676 4674 4675 -3408 111 4679 4677 4678 -3409 111 4682 4680 4681 -3410 111 4685 4683 4684 -3411 111 4688 4686 4687 -3412 111 4691 4689 4690 -3413 111 4694 4692 4693 -3414 111 4697 4695 4696 -3415 111 4700 4698 4699 -3416 111 4703 4701 4702 -3417 111 4706 4704 4705 -3418 111 4709 4707 4708 -3419 111 4712 4710 4711 -3420 111 4715 4713 4714 -3421 111 4718 4716 4717 -3422 111 4721 4719 4720 -3423 111 4724 4722 4723 -3424 111 4727 4725 4726 -3425 111 4730 4728 4729 -3426 111 4733 4731 4732 -3427 111 4736 4734 4735 -3428 111 4739 4737 4738 -3429 111 4742 4740 4741 -3430 111 4745 4743 4744 -3431 111 4748 4746 4747 -3432 111 4751 4749 4750 -3433 111 4754 4752 4753 -3434 111 4757 4755 4756 -3435 111 4760 4758 4759 -3436 111 4763 4761 4762 -3437 111 4766 4764 4765 -3438 111 4769 4767 4768 -3439 111 4772 4770 4771 -3440 111 4775 4773 4774 -3441 111 4778 4776 4777 -3442 111 4781 4779 4780 -3443 111 4784 4782 4783 -3444 111 4787 4785 4786 -3445 111 4790 4788 4789 -3446 111 4793 4791 4792 -3447 111 4796 4794 4795 -3448 111 4799 4797 4798 -3449 111 4802 4800 4801 -3450 111 4805 4803 4804 -3451 111 4808 4806 4807 -3452 111 4811 4809 4810 -3453 111 4814 4812 4813 -3454 111 4817 4815 4816 -3455 111 4820 4818 4819 -3456 111 4823 4821 4822 -3457 111 4826 4824 4825 -3458 111 4829 4827 4828 -3459 111 4832 4830 4831 -3460 111 4835 4833 4834 -3461 111 4838 4836 4837 -3462 111 4841 4839 4840 -3463 111 4844 4842 4843 -3464 111 4847 4845 4846 -3465 111 4850 4848 4849 -3466 111 4853 4851 4852 -3467 111 4856 4854 4855 -3468 111 4859 4857 4858 -3469 111 4862 4860 4861 -3470 111 4865 4863 4864 -3471 111 4868 4866 4867 -3472 111 4871 4869 4870 -3473 111 4874 4872 4873 -3474 111 4877 4875 4876 -3475 111 4880 4878 4879 -3476 111 4883 4881 4882 -3477 111 4886 4884 4885 -3478 111 4889 4887 4888 -3479 111 4892 4890 4891 -3480 111 4895 4893 4894 -3481 111 4898 4896 4897 -3482 111 4901 4899 4900 -3483 111 4904 4902 4903 -3484 111 4907 4905 4906 -3485 111 4910 4908 4909 -3486 111 4913 4911 4912 -3487 111 4916 4914 4915 -3488 111 4919 4917 4918 -3489 111 4922 4920 4921 -3490 111 4925 4923 4924 -3491 111 4928 4926 4927 -3492 111 4931 4929 4930 -3493 111 4934 4932 4933 -3494 111 4937 4935 4936 -3495 111 4940 4938 4939 -3496 111 4943 4941 4942 -3497 111 4946 4944 4945 -3498 111 4949 4947 4948 -3499 111 4952 4950 4951 -3500 111 4955 4953 4954 -3501 111 4958 4956 4957 -3502 111 4961 4959 4960 -3503 111 4964 4962 4963 -3504 111 4967 4965 4966 -3505 111 4970 4968 4969 -3506 111 4973 4971 4972 -3507 111 4976 4974 4975 -3508 111 4979 4977 4978 -3509 111 4982 4980 4981 -3510 111 4985 4983 4984 -3511 111 4988 4986 4987 -3512 111 4991 4989 4990 -3513 111 4994 4992 4993 -3514 111 4997 4995 4996 -3515 111 5000 4998 4999 -3516 111 5003 5001 5002 -3517 111 5006 5004 5005 -3518 111 5009 5007 5008 -3519 111 5012 5010 5011 -3520 111 5015 5013 5014 -3521 111 5018 5016 5017 -3522 111 5021 5019 5020 -3523 111 5024 5022 5023 -3524 111 5027 5025 5026 -3525 111 5030 5028 5029 -3526 111 5033 5031 5032 -3527 111 5036 5034 5035 -3528 111 5039 5037 5038 -3529 111 5042 5040 5041 -3530 111 5045 5043 5044 -3531 111 5048 5046 5047 -3532 111 5051 5049 5050 -3533 111 5054 5052 5053 -3534 111 5057 5055 5056 -3535 111 5060 5058 5059 -3536 111 5063 5061 5062 -3537 111 5066 5064 5065 -3538 111 5069 5067 5068 -3539 111 5072 5070 5071 -3540 111 5075 5073 5074 -3541 111 5078 5076 5077 -3542 111 5081 5079 5080 -3543 111 5084 5082 5083 -3544 111 5087 5085 5086 -3545 111 5090 5088 5089 -3546 111 5093 5091 5092 -3547 111 5096 5094 5095 -3548 111 5099 5097 5098 -3549 111 5102 5100 5101 -3550 111 5105 5103 5104 -3551 111 5108 5106 5107 -3552 111 5111 5109 5110 -3553 111 5114 5112 5113 -3554 111 5117 5115 5116 -3555 111 5120 5118 5119 -3556 111 5123 5121 5122 -3557 111 5126 5124 5125 -3558 111 5129 5127 5128 -3559 111 5132 5130 5131 -3560 111 5135 5133 5134 -3561 111 5138 5136 5137 -3562 111 5141 5139 5140 -3563 111 5144 5142 5143 -3564 111 5147 5145 5146 -3565 111 5150 5148 5149 -3566 111 5153 5151 5152 -3567 111 5156 5154 5155 -3568 111 5159 5157 5158 -3569 111 5162 5160 5161 -3570 111 5165 5163 5164 -3571 111 5168 5166 5167 -3572 111 5171 5169 5170 -3573 111 5174 5172 5173 -3574 111 5177 5175 5176 -3575 111 5180 5178 5179 -3576 111 5183 5181 5182 -3577 111 5186 5184 5185 -3578 111 5189 5187 5188 -3579 111 5192 5190 5191 -3580 111 5195 5193 5194 -3581 111 5198 5196 5197 -3582 111 5201 5199 5200 -3583 111 5204 5202 5203 -3584 111 5207 5205 5206 -3585 111 5210 5208 5209 -3586 111 5213 5211 5212 -3587 111 5216 5214 5215 -3588 111 5219 5217 5218 -3589 111 5222 5220 5221 -3590 111 5225 5223 5224 -3591 111 5228 5226 5227 -3592 111 5231 5229 5230 -3593 111 5234 5232 5233 -3594 111 5237 5235 5236 -3595 111 5240 5238 5239 -3596 111 5243 5241 5242 -3597 111 5246 5244 5245 -3598 111 5249 5247 5248 -3599 111 5252 5250 5251 -3600 111 5255 5253 5254 -3601 111 5258 5256 5257 -3602 111 5261 5259 5260 -3603 111 5264 5262 5263 -3604 111 5267 5265 5266 -3605 111 5270 5268 5269 -3606 111 5273 5271 5272 -3607 111 5276 5274 5275 -3608 111 5279 5277 5278 -3609 111 5282 5280 5281 -3610 111 5285 5283 5284 -3611 111 5288 5286 5287 -3612 111 5291 5289 5290 -3613 111 5294 5292 5293 -3614 111 5297 5295 5296 -3615 111 5300 5298 5299 -3616 111 5303 5301 5302 -3617 111 5306 5304 5305 -3618 111 5309 5307 5308 -3619 111 5312 5310 5311 -3620 111 5315 5313 5314 -3621 111 5318 5316 5317 -3622 111 5321 5319 5320 -3623 111 5324 5322 5323 -3624 111 5327 5325 5326 -3625 111 5330 5328 5329 -3626 111 5333 5331 5332 -3627 111 5336 5334 5335 -3628 111 5339 5337 5338 -3629 111 5342 5340 5341 -3630 111 5345 5343 5344 -3631 111 5348 5346 5347 -3632 111 5351 5349 5350 -3633 111 5354 5352 5353 -3634 111 5357 5355 5356 -3635 111 5360 5358 5359 -3636 111 5363 5361 5362 -3637 111 5366 5364 5365 -3638 111 5369 5367 5368 -3639 111 5372 5370 5371 -3640 111 5375 5373 5374 -3641 111 5378 5376 5377 -3642 111 5381 5379 5380 -3643 111 5384 5382 5383 -3644 111 5387 5385 5386 -3645 111 5390 5388 5389 -3646 111 5393 5391 5392 -3647 111 5396 5394 5395 -3648 111 5399 5397 5398 -3649 111 5402 5400 5401 -3650 111 5405 5403 5404 -3651 111 5408 5406 5407 -3652 111 5411 5409 5410 -3653 111 5414 5412 5413 -3654 111 5417 5415 5416 -3655 111 5420 5418 5419 -3656 111 5423 5421 5422 -3657 111 5426 5424 5425 -3658 111 5429 5427 5428 -3659 111 5432 5430 5431 -3660 111 5435 5433 5434 -3661 111 5438 5436 5437 -3662 111 5441 5439 5440 -3663 111 5444 5442 5443 -3664 111 5447 5445 5446 -3665 111 5450 5448 5449 -3666 111 5453 5451 5452 -3667 111 5456 5454 5455 -3668 111 5459 5457 5458 -3669 111 5462 5460 5461 -3670 111 5465 5463 5464 -3671 111 5468 5466 5467 -3672 111 5471 5469 5470 -3673 111 5474 5472 5473 -3674 111 5477 5475 5476 -3675 111 5480 5478 5479 -3676 111 5483 5481 5482 -3677 111 5486 5484 5485 -3678 111 5489 5487 5488 -3679 111 5492 5490 5491 -3680 111 5495 5493 5494 -3681 111 5498 5496 5497 -3682 111 5501 5499 5500 -3683 111 5504 5502 5503 -3684 111 5507 5505 5506 -3685 111 5510 5508 5509 -3686 111 5513 5511 5512 -3687 111 5516 5514 5515 -3688 111 5519 5517 5518 -3689 111 5522 5520 5521 -3690 111 5525 5523 5524 -3691 111 5528 5526 5527 -3692 111 5531 5529 5530 -3693 111 5534 5532 5533 -3694 111 5537 5535 5536 -3695 111 5540 5538 5539 -3696 111 5543 5541 5542 -3697 111 5546 5544 5545 -3698 111 5549 5547 5548 -3699 111 5552 5550 5551 -3700 111 5555 5553 5554 -3701 111 5558 5556 5557 -3702 111 5561 5559 5560 -3703 111 5564 5562 5563 -3704 111 5567 5565 5566 -3705 111 5570 5568 5569 -3706 111 5573 5571 5572 -3707 111 5576 5574 5575 -3708 111 5579 5577 5578 -3709 111 5582 5580 5581 -3710 111 5585 5583 5584 -3711 111 5588 5586 5587 -3712 111 5591 5589 5590 -3713 111 5594 5592 5593 -3714 111 5597 5595 5596 -3715 111 5600 5598 5599 -3716 111 5603 5601 5602 -3717 111 5606 5604 5605 -3718 111 5609 5607 5608 -3719 111 5612 5610 5611 -3720 111 5615 5613 5614 -3721 111 5618 5616 5617 -3722 111 5621 5619 5620 -3723 111 5624 5622 5623 -3724 111 5627 5625 5626 -3725 111 5630 5628 5629 -3726 111 5633 5631 5632 -3727 111 5636 5634 5635 -3728 111 5639 5637 5638 -3729 111 5642 5640 5641 -3730 111 5645 5643 5644 -3731 111 5648 5646 5647 -3732 111 5651 5649 5650 -3733 111 5654 5652 5653 -3734 111 5657 5655 5656 -3735 111 5660 5658 5659 -3736 111 5663 5661 5662 -3737 111 5666 5664 5665 -3738 111 5669 5667 5668 -3739 111 5672 5670 5671 -3740 111 5675 5673 5674 -3741 111 5678 5676 5677 -3742 111 5681 5679 5680 -3743 111 5684 5682 5683 -3744 111 5687 5685 5686 -3745 111 5690 5688 5689 -3746 111 5693 5691 5692 -3747 111 5696 5694 5695 -3748 111 5699 5697 5698 -3749 111 5702 5700 5701 -3750 111 5705 5703 5704 -3751 111 5708 5706 5707 -3752 111 5711 5709 5710 -3753 111 5714 5712 5713 -3754 111 5717 5715 5716 -3755 111 5720 5718 5719 -3756 111 5723 5721 5722 -3757 111 5726 5724 5725 -3758 111 5729 5727 5728 -3759 111 5732 5730 5731 -3760 111 5735 5733 5734 -3761 111 5738 5736 5737 -3762 111 5741 5739 5740 -3763 111 5744 5742 5743 -3764 111 5747 5745 5746 -3765 111 5750 5748 5749 -3766 111 5753 5751 5752 -3767 111 5756 5754 5755 -3768 111 5759 5757 5758 -3769 111 5762 5760 5761 -3770 111 5765 5763 5764 -3771 111 5768 5766 5767 -3772 111 5771 5769 5770 -3773 111 5774 5772 5773 -3774 111 5777 5775 5776 -3775 111 5780 5778 5779 -3776 111 5783 5781 5782 -3777 111 5786 5784 5785 -3778 111 5789 5787 5788 -3779 111 5792 5790 5791 -3780 111 5795 5793 5794 -3781 111 5798 5796 5797 -3782 111 5801 5799 5800 -3783 111 5804 5802 5803 -3784 111 5807 5805 5806 -3785 111 5810 5808 5809 -3786 111 5813 5811 5812 -3787 111 5816 5814 5815 -3788 111 5819 5817 5818 -3789 111 5822 5820 5821 -3790 111 5825 5823 5824 -3791 111 5828 5826 5827 -3792 111 5831 5829 5830 -3793 111 5834 5832 5833 -3794 111 5837 5835 5836 -3795 111 5840 5838 5839 -3796 111 5843 5841 5842 -3797 111 5846 5844 5845 -3798 111 5849 5847 5848 -3799 111 5852 5850 5851 -3800 111 5855 5853 5854 -3801 111 5858 5856 5857 -3802 111 5861 5859 5860 -3803 111 5864 5862 5863 -3804 111 5867 5865 5866 -3805 111 5870 5868 5869 -3806 111 5873 5871 5872 -3807 111 5876 5874 5875 -3808 111 5879 5877 5878 -3809 111 5882 5880 5881 -3810 111 5885 5883 5884 -3811 111 5888 5886 5887 -3812 111 5891 5889 5890 -3813 111 5894 5892 5893 -3814 111 5897 5895 5896 -3815 111 5900 5898 5899 -3816 111 5903 5901 5902 -3817 111 5906 5904 5905 -3818 111 5909 5907 5908 -3819 111 5912 5910 5911 -3820 111 5915 5913 5914 -3821 111 5918 5916 5917 -3822 111 5921 5919 5920 -3823 111 5924 5922 5923 -3824 111 5927 5925 5926 -3825 111 5930 5928 5929 -3826 111 5933 5931 5932 -3827 111 5936 5934 5935 -3828 111 5939 5937 5938 -3829 111 5942 5940 5941 -3830 111 5945 5943 5944 -3831 111 5948 5946 5947 -3832 111 5951 5949 5950 -3833 111 5954 5952 5953 -3834 111 5957 5955 5956 -3835 111 5960 5958 5959 -3836 111 5963 5961 5962 -3837 111 5966 5964 5965 -3838 111 5969 5967 5968 -3839 111 5972 5970 5971 -3840 111 5975 5973 5974 -3841 111 5978 5976 5977 -3842 111 5981 5979 5980 -3843 111 5984 5982 5983 -3844 111 5987 5985 5986 -3845 111 5990 5988 5989 -3846 111 5993 5991 5992 -3847 111 5996 5994 5995 -3848 111 5999 5997 5998 -3849 111 6002 6000 6001 -3850 111 6005 6003 6004 -3851 111 6008 6006 6007 -3852 111 6011 6009 6010 -3853 111 6014 6012 6013 -3854 111 6017 6015 6016 -3855 111 6020 6018 6019 -3856 111 6023 6021 6022 -3857 111 6026 6024 6025 -3858 111 6029 6027 6028 -3859 111 6032 6030 6031 -3860 111 6035 6033 6034 -3861 111 6038 6036 6037 -3862 111 6041 6039 6040 -3863 111 6044 6042 6043 -3864 111 6047 6045 6046 -3865 111 6050 6048 6049 -3866 111 6053 6051 6052 -3867 111 6056 6054 6055 -3868 111 6059 6057 6058 -3869 111 6062 6060 6061 -3870 111 6065 6063 6064 -3871 111 6068 6066 6067 -3872 111 6071 6069 6070 -3873 111 6074 6072 6073 -3874 111 6077 6075 6076 -3875 111 6080 6078 6079 -3876 111 6083 6081 6082 -3877 111 6086 6084 6085 -3878 111 6089 6087 6088 -3879 111 6092 6090 6091 -3880 111 6095 6093 6094 -3881 111 6098 6096 6097 -3882 111 6101 6099 6100 -3883 111 6104 6102 6103 -3884 111 6107 6105 6106 -3885 111 6110 6108 6109 -3886 111 6113 6111 6112 -3887 111 6116 6114 6115 -3888 111 6119 6117 6118 -3889 111 6122 6120 6121 -3890 111 6125 6123 6124 -3891 111 6128 6126 6127 -3892 111 6131 6129 6130 -3893 111 6134 6132 6133 -3894 111 6137 6135 6136 -3895 111 6140 6138 6139 -3896 111 6143 6141 6142 -3897 111 6146 6144 6145 -3898 111 6149 6147 6148 -3899 111 6152 6150 6151 -3900 111 6155 6153 6154 -3901 111 6158 6156 6157 -3902 111 6161 6159 6160 -3903 111 6164 6162 6163 -3904 111 6167 6165 6166 -3905 111 6170 6168 6169 -3906 111 6173 6171 6172 -3907 111 6176 6174 6175 -3908 111 6179 6177 6178 -3909 111 6182 6180 6181 -3910 111 6185 6183 6184 -3911 111 6188 6186 6187 -3912 111 6191 6189 6190 -3913 111 6194 6192 6193 -3914 111 6197 6195 6196 -3915 111 6200 6198 6199 -3916 111 6203 6201 6202 -3917 111 6206 6204 6205 -3918 111 6209 6207 6208 -3919 111 6212 6210 6211 -3920 111 6215 6213 6214 -3921 111 6218 6216 6217 -3922 111 6221 6219 6220 -3923 111 6224 6222 6223 -3924 111 6227 6225 6226 -3925 111 6230 6228 6229 -3926 111 6233 6231 6232 -3927 111 6236 6234 6235 -3928 111 6239 6237 6238 -3929 111 6242 6240 6241 -3930 111 6245 6243 6244 -3931 111 6248 6246 6247 -3932 111 6251 6249 6250 -3933 111 6254 6252 6253 -3934 111 6257 6255 6256 -3935 111 6260 6258 6259 -3936 111 6263 6261 6262 -3937 111 6266 6264 6265 -3938 111 6269 6267 6268 -3939 111 6272 6270 6271 -3940 111 6275 6273 6274 -3941 111 6278 6276 6277 -3942 111 6281 6279 6280 -3943 111 6284 6282 6283 -3944 111 6287 6285 6286 -3945 111 6290 6288 6289 -3946 111 6293 6291 6292 -3947 111 6296 6294 6295 -3948 111 6299 6297 6298 -3949 111 6302 6300 6301 -3950 111 6305 6303 6304 -3951 111 6308 6306 6307 -3952 111 6311 6309 6310 -3953 111 6314 6312 6313 -3954 111 6317 6315 6316 -3955 111 6320 6318 6319 -3956 111 6323 6321 6322 -3957 111 6326 6324 6325 -3958 111 6329 6327 6328 -3959 111 6332 6330 6331 -3960 111 6335 6333 6334 -3961 111 6338 6336 6337 -3962 111 6341 6339 6340 -3963 111 6344 6342 6343 -3964 111 6347 6345 6346 -3965 111 6350 6348 6349 -3966 111 6353 6351 6352 -3967 111 6356 6354 6355 -3968 111 6359 6357 6358 -3969 111 6362 6360 6361 -3970 111 6365 6363 6364 -3971 111 6368 6366 6367 -3972 111 6371 6369 6370 -3973 111 6374 6372 6373 -3974 111 6377 6375 6376 -3975 111 6380 6378 6379 -3976 111 6383 6381 6382 -3977 111 6386 6384 6385 -3978 111 6389 6387 6388 -3979 111 6392 6390 6391 -3980 111 6395 6393 6394 -3981 111 6398 6396 6397 -3982 111 6401 6399 6400 -3983 111 6404 6402 6403 -3984 111 6407 6405 6406 -3985 111 6410 6408 6409 -3986 111 6413 6411 6412 -3987 111 6416 6414 6415 -3988 111 6419 6417 6418 -3989 111 6422 6420 6421 -3990 111 6425 6423 6424 -3991 111 6428 6426 6427 -3992 111 6431 6429 6430 -3993 111 6434 6432 6433 -3994 111 6437 6435 6436 -3995 111 6440 6438 6439 -3996 111 6443 6441 6442 -3997 111 6446 6444 6445 -3998 111 6449 6447 6448 -3999 111 6452 6450 6451 -4000 111 6455 6453 6454 -4001 111 6458 6456 6457 -4002 111 6461 6459 6460 -4003 111 6464 6462 6463 -4004 111 6467 6465 6466 -4005 111 6470 6468 6469 -4006 111 6473 6471 6472 -4007 111 6476 6474 6475 -4008 111 6479 6477 6478 -4009 111 6482 6480 6481 -4010 111 6485 6483 6484 -4011 111 6488 6486 6487 -4012 111 6491 6489 6490 -4013 111 6494 6492 6493 -4014 111 6497 6495 6496 -4015 111 6500 6498 6499 -4016 111 6503 6501 6502 -4017 111 6506 6504 6505 -4018 111 6509 6507 6508 -4019 111 6512 6510 6511 -4020 111 6515 6513 6514 -4021 111 6518 6516 6517 -4022 111 6521 6519 6520 -4023 111 6524 6522 6523 -4024 111 6527 6525 6526 -4025 111 6530 6528 6529 -4026 111 6533 6531 6532 -4027 111 6536 6534 6535 -4028 111 6539 6537 6538 -4029 111 6542 6540 6541 -4030 111 6545 6543 6544 -4031 111 6548 6546 6547 -4032 111 6551 6549 6550 -4033 111 6554 6552 6553 -4034 111 6557 6555 6556 -4035 111 6560 6558 6559 -4036 111 6563 6561 6562 -4037 111 6566 6564 6565 -4038 111 6569 6567 6568 -4039 111 6572 6570 6571 -4040 111 6575 6573 6574 -4041 111 6578 6576 6577 -4042 111 6581 6579 6580 -4043 111 6584 6582 6583 -4044 111 6587 6585 6586 -4045 111 6590 6588 6589 -4046 111 6593 6591 6592 -4047 111 6596 6594 6595 -4048 111 6599 6597 6598 -4049 111 6602 6600 6601 -4050 111 6605 6603 6604 -4051 111 6608 6606 6607 -4052 111 6611 6609 6610 -4053 111 6614 6612 6613 -4054 111 6617 6615 6616 -4055 111 6620 6618 6619 -4056 111 6623 6621 6622 -4057 111 6626 6624 6625 -4058 111 6629 6627 6628 -4059 111 6632 6630 6631 -4060 111 6635 6633 6634 -4061 111 6638 6636 6637 -4062 111 6641 6639 6640 -4063 111 6644 6642 6643 -4064 111 6647 6645 6646 -4065 111 6650 6648 6649 -4066 111 6653 6651 6652 -4067 111 6656 6654 6655 -4068 111 6659 6657 6658 -4069 111 6662 6660 6661 -4070 111 6665 6663 6664 -4071 111 6668 6666 6667 -4072 111 6671 6669 6670 -4073 111 6674 6672 6673 -4074 111 6677 6675 6676 -4075 111 6680 6678 6679 -4076 111 6683 6681 6682 -4077 111 6686 6684 6685 -4078 111 6689 6687 6688 -4079 111 6692 6690 6691 -4080 111 6695 6693 6694 -4081 111 6698 6696 6697 -4082 111 6701 6699 6700 -4083 111 6704 6702 6703 -4084 111 6707 6705 6706 -4085 111 6710 6708 6709 -4086 111 6713 6711 6712 -4087 111 6716 6714 6715 -4088 111 6719 6717 6718 -4089 111 6722 6720 6721 -4090 111 6725 6723 6724 -4091 111 6728 6726 6727 -4092 111 6731 6729 6730 -4093 111 6734 6732 6733 -4094 111 6737 6735 6736 -4095 111 6740 6738 6739 -4096 111 6743 6741 6742 -4097 111 6746 6744 6745 -4098 111 6749 6747 6748 -4099 111 6752 6750 6751 -4100 111 6755 6753 6754 -4101 111 6758 6756 6757 -4102 111 6761 6759 6760 -4103 111 6764 6762 6763 -4104 111 6767 6765 6766 -4105 111 6770 6768 6769 -4106 111 6773 6771 6772 -4107 111 6776 6774 6775 -4108 111 6779 6777 6778 -4109 111 6782 6780 6781 -4110 111 6785 6783 6784 -4111 111 6788 6786 6787 -4112 111 6791 6789 6790 -4113 111 6794 6792 6793 -4114 111 6797 6795 6796 -4115 111 6800 6798 6799 -4116 111 6803 6801 6802 -4117 111 6806 6804 6805 -4118 111 6809 6807 6808 -4119 111 6812 6810 6811 -4120 111 6815 6813 6814 -4121 111 6818 6816 6817 -4122 111 6821 6819 6820 -4123 111 6824 6822 6823 -4124 111 6827 6825 6826 -4125 111 6830 6828 6829 -4126 111 6833 6831 6832 -4127 111 6836 6834 6835 -4128 111 6839 6837 6838 -4129 111 6842 6840 6841 -4130 111 6845 6843 6844 -4131 111 6848 6846 6847 -4132 111 6851 6849 6850 -4133 111 6854 6852 6853 -4134 111 6857 6855 6856 -4135 111 6860 6858 6859 -4136 111 6863 6861 6862 -4137 111 6866 6864 6865 -4138 111 6869 6867 6868 -4139 111 6872 6870 6871 -4140 111 6875 6873 6874 -4141 111 6878 6876 6877 -4142 111 6881 6879 6880 -4143 111 6884 6882 6883 -4144 111 6887 6885 6886 -4145 111 6890 6888 6889 -4146 111 6893 6891 6892 -4147 111 6896 6894 6895 -4148 111 6899 6897 6898 -4149 111 6902 6900 6901 -4150 111 6905 6903 6904 -4151 111 6908 6906 6907 -4152 111 6911 6909 6910 -4153 111 6914 6912 6913 -4154 111 6917 6915 6916 -4155 111 6920 6918 6919 -4156 111 6923 6921 6922 -4157 111 6926 6924 6925 -4158 111 6929 6927 6928 -4159 111 6932 6930 6931 -4160 111 6935 6933 6934 -4161 111 6938 6936 6937 -4162 111 6941 6939 6940 -4163 111 6944 6942 6943 -4164 111 6947 6945 6946 -4165 111 6950 6948 6949 -4166 111 6953 6951 6952 -4167 111 6956 6954 6955 -4168 111 6959 6957 6958 -4169 111 6962 6960 6961 -4170 111 6965 6963 6964 -4171 111 6968 6966 6967 -4172 111 6971 6969 6970 -4173 111 6974 6972 6973 -4174 111 6977 6975 6976 -4175 111 6980 6978 6979 -4176 111 6983 6981 6982 -4177 111 6986 6984 6985 -4178 111 6989 6987 6988 -4179 111 6992 6990 6991 -4180 111 6995 6993 6994 -4181 111 6998 6996 6997 -4182 111 7001 6999 7000 -4183 111 7004 7002 7003 -4184 111 7007 7005 7006 -4185 111 7010 7008 7009 -4186 111 7013 7011 7012 -4187 111 7016 7014 7015 -4188 111 7019 7017 7018 -4189 111 7022 7020 7021 -4190 111 7025 7023 7024 -4191 111 7028 7026 7027 -4192 111 7031 7029 7030 -4193 111 7034 7032 7033 -4194 111 7037 7035 7036 -4195 111 7040 7038 7039 -4196 111 7043 7041 7042 -4197 111 7046 7044 7045 -4198 111 7049 7047 7048 -4199 111 7052 7050 7051 -4200 111 7055 7053 7054 -4201 111 7058 7056 7057 -4202 111 7061 7059 7060 -4203 111 7064 7062 7063 -4204 111 7067 7065 7066 -4205 111 7070 7068 7069 -4206 111 7073 7071 7072 -4207 111 7076 7074 7075 -4208 111 7079 7077 7078 -4209 111 7082 7080 7081 -4210 111 7085 7083 7084 -4211 111 7088 7086 7087 -4212 111 7091 7089 7090 -4213 111 7094 7092 7093 -4214 111 7097 7095 7096 -4215 111 7100 7098 7099 -4216 111 7103 7101 7102 -4217 111 7106 7104 7105 -4218 111 7109 7107 7108 -4219 111 7112 7110 7111 -4220 111 7115 7113 7114 -4221 111 7118 7116 7117 -4222 111 7121 7119 7120 -4223 111 7124 7122 7123 -4224 111 7127 7125 7126 -4225 111 7130 7128 7129 -4226 111 7133 7131 7132 -4227 111 7136 7134 7135 -4228 111 7139 7137 7138 -4229 111 7142 7140 7141 -4230 111 7145 7143 7144 -4231 111 7148 7146 7147 -4232 111 7151 7149 7150 -4233 111 7154 7152 7153 -4234 111 7157 7155 7156 -4235 111 7160 7158 7159 -4236 111 7163 7161 7162 -4237 111 7166 7164 7165 -4238 111 7169 7167 7168 -4239 111 7172 7170 7171 -4240 111 7175 7173 7174 -4241 111 7178 7176 7177 -4242 111 7181 7179 7180 -4243 111 7184 7182 7183 -4244 111 7187 7185 7186 -4245 111 7190 7188 7189 -4246 111 7193 7191 7192 -4247 111 7196 7194 7195 -4248 111 7199 7197 7198 -4249 111 7202 7200 7201 -4250 111 7205 7203 7204 -4251 111 7208 7206 7207 -4252 111 7211 7209 7210 -4253 111 7214 7212 7213 -4254 111 7217 7215 7216 -4255 111 7220 7218 7219 -4256 111 7223 7221 7222 -4257 111 7226 7224 7225 -4258 111 7229 7227 7228 -4259 111 7232 7230 7231 -4260 111 7235 7233 7234 -4261 111 7238 7236 7237 -4262 111 7241 7239 7240 -4263 111 7244 7242 7243 -4264 111 7247 7245 7246 -4265 111 7250 7248 7249 -4266 111 7253 7251 7252 -4267 111 7256 7254 7255 -4268 111 7259 7257 7258 -4269 111 7262 7260 7261 -4270 111 7265 7263 7264 -4271 111 7268 7266 7267 -4272 111 7271 7269 7270 -4273 111 7274 7272 7273 -4274 111 7277 7275 7276 -4275 111 7280 7278 7279 -4276 111 7283 7281 7282 -4277 111 7286 7284 7285 -4278 111 7289 7287 7288 -4279 111 7292 7290 7291 -4280 111 7295 7293 7294 -4281 111 7298 7296 7297 -4282 111 7301 7299 7300 -4283 111 7304 7302 7303 -4284 111 7307 7305 7306 -4285 111 7310 7308 7309 -4286 111 7313 7311 7312 -4287 111 7316 7314 7315 -4288 111 7319 7317 7318 -4289 111 7322 7320 7321 -4290 111 7325 7323 7324 -4291 111 7328 7326 7327 -4292 111 7331 7329 7330 -4293 111 7334 7332 7333 -4294 111 7337 7335 7336 -4295 111 7340 7338 7339 -4296 111 7343 7341 7342 -4297 111 7346 7344 7345 -4298 111 7349 7347 7348 -4299 111 7352 7350 7351 -4300 111 7355 7353 7354 -4301 111 7358 7356 7357 -4302 111 7361 7359 7360 -4303 111 7364 7362 7363 -4304 111 7367 7365 7366 -4305 111 7370 7368 7369 -4306 111 7373 7371 7372 -4307 111 7376 7374 7375 -4308 111 7379 7377 7378 -4309 111 7382 7380 7381 -4310 111 7385 7383 7384 -4311 111 7388 7386 7387 -4312 111 7391 7389 7390 -4313 111 7394 7392 7393 -4314 111 7397 7395 7396 -4315 111 7400 7398 7399 -4316 111 7403 7401 7402 -4317 111 7406 7404 7405 -4318 111 7409 7407 7408 -4319 111 7412 7410 7411 -4320 111 7415 7413 7414 -4321 111 7418 7416 7417 -4322 111 7421 7419 7420 -4323 111 7424 7422 7423 -4324 111 7427 7425 7426 -4325 111 7430 7428 7429 -4326 111 7433 7431 7432 -4327 111 7436 7434 7435 -4328 111 7439 7437 7438 -4329 111 7442 7440 7441 -4330 111 7445 7443 7444 -4331 111 7448 7446 7447 -4332 111 7451 7449 7450 -4333 111 7454 7452 7453 -4334 111 7457 7455 7456 -4335 111 7460 7458 7459 -4336 111 7463 7461 7462 -4337 111 7466 7464 7465 -4338 111 7469 7467 7468 -4339 111 7472 7470 7471 -4340 111 7475 7473 7474 -4341 111 7478 7476 7477 -4342 111 7481 7479 7480 -4343 111 7484 7482 7483 -4344 111 7487 7485 7486 -4345 111 7490 7488 7489 -4346 111 7493 7491 7492 -4347 111 7496 7494 7495 -4348 111 7499 7497 7498 -4349 111 7502 7500 7501 -4350 111 7505 7503 7504 -4351 111 7508 7506 7507 -4352 111 7511 7509 7510 -4353 111 7514 7512 7513 -4354 111 7517 7515 7516 -4355 111 7520 7518 7519 -4356 111 7523 7521 7522 -4357 111 7526 7524 7525 -4358 111 7529 7527 7528 -4359 111 7532 7530 7531 -4360 111 7535 7533 7534 -4361 111 7538 7536 7537 -4362 111 7541 7539 7540 -4363 111 7544 7542 7543 -4364 111 7547 7545 7546 -4365 111 7550 7548 7549 -4366 111 7553 7551 7552 -4367 111 7556 7554 7555 -4368 111 7559 7557 7558 -4369 111 7562 7560 7561 -4370 111 7565 7563 7564 -4371 111 7568 7566 7567 -4372 111 7571 7569 7570 -4373 111 7574 7572 7573 -4374 111 7577 7575 7576 -4375 111 7580 7578 7579 -4376 111 7583 7581 7582 -4377 111 7586 7584 7585 -4378 111 7589 7587 7588 -4379 111 7592 7590 7591 -4380 111 7595 7593 7594 -4381 111 7598 7596 7597 -4382 111 7601 7599 7600 -4383 111 7604 7602 7603 -4384 111 7607 7605 7606 -4385 111 7610 7608 7609 -4386 111 7613 7611 7612 -4387 111 7616 7614 7615 -4388 111 7619 7617 7618 -4389 111 7622 7620 7621 -4390 111 7625 7623 7624 -4391 111 7628 7626 7627 -4392 111 7631 7629 7630 -4393 111 7634 7632 7633 -4394 111 7637 7635 7636 -4395 111 7640 7638 7639 -4396 111 7643 7641 7642 -4397 111 7646 7644 7645 -4398 111 7649 7647 7648 -4399 111 7652 7650 7651 -4400 111 7655 7653 7654 -4401 111 7658 7656 7657 -4402 111 7661 7659 7660 -4403 111 7664 7662 7663 -4404 111 7667 7665 7666 -4405 111 7670 7668 7669 -4406 111 7673 7671 7672 -4407 111 7676 7674 7675 -4408 111 7679 7677 7678 -4409 111 7682 7680 7681 -4410 111 7685 7683 7684 -4411 111 7688 7686 7687 -4412 111 7691 7689 7690 -4413 111 7694 7692 7693 -4414 111 7697 7695 7696 -4415 111 7700 7698 7699 -4416 111 7703 7701 7702 -4417 111 7706 7704 7705 -4418 111 7709 7707 7708 -4419 111 7712 7710 7711 -4420 111 7715 7713 7714 -4421 111 7718 7716 7717 -4422 111 7721 7719 7720 -4423 111 7724 7722 7723 -4424 111 7727 7725 7726 -4425 111 7730 7728 7729 -4426 111 7733 7731 7732 -4427 111 7736 7734 7735 -4428 111 7739 7737 7738 -4429 111 7742 7740 7741 -4430 111 7745 7743 7744 -4431 111 7748 7746 7747 -4432 111 7751 7749 7750 -4433 111 7754 7752 7753 -4434 111 7757 7755 7756 -4435 111 7760 7758 7759 -4436 111 7763 7761 7762 -4437 111 7766 7764 7765 -4438 111 7769 7767 7768 -4439 111 7772 7770 7771 -4440 111 7775 7773 7774 -4441 111 7778 7776 7777 -4442 111 7781 7779 7780 -4443 111 7784 7782 7783 -4444 111 7787 7785 7786 -4445 111 7790 7788 7789 -4446 111 7793 7791 7792 -4447 111 7796 7794 7795 -4448 111 7799 7797 7798 -4449 111 7802 7800 7801 -4450 111 7805 7803 7804 -4451 111 7808 7806 7807 -4452 111 7811 7809 7810 -4453 111 7814 7812 7813 -4454 111 7817 7815 7816 -4455 111 7820 7818 7819 -4456 111 7823 7821 7822 -4457 111 7826 7824 7825 -4458 111 7829 7827 7828 -4459 111 7832 7830 7831 -4460 111 7835 7833 7834 -4461 111 7838 7836 7837 -4462 111 7841 7839 7840 -4463 111 7844 7842 7843 -4464 111 7847 7845 7846 -4465 111 7850 7848 7849 -4466 111 7853 7851 7852 -4467 111 7856 7854 7855 -4468 111 7859 7857 7858 -4469 111 7862 7860 7861 -4470 111 7865 7863 7864 -4471 111 7868 7866 7867 -4472 111 7871 7869 7870 -4473 111 7874 7872 7873 -4474 111 7877 7875 7876 -4475 111 7880 7878 7879 -4476 111 7883 7881 7882 -4477 111 7886 7884 7885 -4478 111 7889 7887 7888 -4479 111 7892 7890 7891 -4480 111 7895 7893 7894 -4481 111 7898 7896 7897 -4482 111 7901 7899 7900 -4483 111 7904 7902 7903 -4484 111 7907 7905 7906 -4485 111 7910 7908 7909 -4486 111 7913 7911 7912 -4487 111 7916 7914 7915 -4488 111 7919 7917 7918 -4489 111 7922 7920 7921 -4490 111 7925 7923 7924 -4491 111 7928 7926 7927 -4492 111 7931 7929 7930 -4493 111 7934 7932 7933 -4494 111 7937 7935 7936 -4495 111 7940 7938 7939 -4496 111 7943 7941 7942 -4497 111 7946 7944 7945 -4498 111 7949 7947 7948 -4499 111 7952 7950 7951 -4500 111 7955 7953 7954 -4501 111 7958 7956 7957 -4502 111 7961 7959 7960 -4503 111 7964 7962 7963 -4504 111 7967 7965 7966 -4505 111 7970 7968 7969 -4506 111 7973 7971 7972 -4507 111 7976 7974 7975 -4508 111 7979 7977 7978 -4509 111 7982 7980 7981 -4510 111 7985 7983 7984 -4511 111 7988 7986 7987 -4512 111 7991 7989 7990 -4513 111 7994 7992 7993 -4514 111 7997 7995 7996 -4515 111 8000 7998 7999 -4516 111 8003 8001 8002 -4517 111 8006 8004 8005 -4518 111 8009 8007 8008 -4519 111 8012 8010 8011 -4520 111 8015 8013 8014 -4521 111 8018 8016 8017 -4522 111 8021 8019 8020 -4523 111 8024 8022 8023 -4524 111 8027 8025 8026 -4525 111 8030 8028 8029 -4526 111 8033 8031 8032 -4527 111 8036 8034 8035 -4528 111 8039 8037 8038 -4529 111 8042 8040 8041 -4530 111 8045 8043 8044 -4531 111 8048 8046 8047 -4532 111 8051 8049 8050 -4533 111 8054 8052 8053 -4534 111 8057 8055 8056 -4535 111 8060 8058 8059 -4536 111 8063 8061 8062 -4537 111 8066 8064 8065 -4538 111 8069 8067 8068 -4539 111 8072 8070 8071 -4540 111 8075 8073 8074 -4541 111 8078 8076 8077 -4542 111 8081 8079 8080 -4543 111 8084 8082 8083 -4544 111 8087 8085 8086 -4545 111 8090 8088 8089 -4546 111 8093 8091 8092 -4547 111 8096 8094 8095 -4548 111 8099 8097 8098 -4549 111 8102 8100 8101 -4550 111 8105 8103 8104 -4551 111 8108 8106 8107 -4552 111 8111 8109 8110 -4553 111 8114 8112 8113 -4554 111 8117 8115 8116 -4555 111 8120 8118 8119 -4556 111 8123 8121 8122 -4557 111 8126 8124 8125 -4558 111 8129 8127 8128 -4559 111 8132 8130 8131 -4560 111 8135 8133 8134 -4561 111 8138 8136 8137 -4562 111 8141 8139 8140 -4563 111 8144 8142 8143 -4564 111 8147 8145 8146 -4565 111 8150 8148 8149 -4566 111 8153 8151 8152 -4567 111 8156 8154 8155 -4568 111 8159 8157 8158 -4569 111 8162 8160 8161 -4570 111 8165 8163 8164 -4571 111 8168 8166 8167 -4572 111 8171 8169 8170 -4573 111 8174 8172 8173 -4574 111 8177 8175 8176 -4575 111 8180 8178 8179 -4576 111 8183 8181 8182 -4577 111 8186 8184 8185 -4578 111 8189 8187 8188 -4579 111 8192 8190 8191 -4580 111 8195 8193 8194 -4581 111 8198 8196 8197 -4582 111 8201 8199 8200 -4583 111 8204 8202 8203 -4584 111 8207 8205 8206 -4585 111 8210 8208 8209 -4586 111 8213 8211 8212 -4587 111 8216 8214 8215 -4588 111 8219 8217 8218 -4589 111 8222 8220 8221 -4590 111 8225 8223 8224 -4591 111 8228 8226 8227 -4592 111 8231 8229 8230 -4593 111 8234 8232 8233 -4594 111 8237 8235 8236 -4595 111 8240 8238 8239 -4596 111 8243 8241 8242 -4597 111 8246 8244 8245 -4598 111 8249 8247 8248 -4599 111 8252 8250 8251 -4600 111 8255 8253 8254 -4601 111 8258 8256 8257 -4602 111 8261 8259 8260 -4603 111 8264 8262 8263 -4604 111 8267 8265 8266 -4605 111 8270 8268 8269 -4606 111 8273 8271 8272 -4607 111 8276 8274 8275 -4608 111 8279 8277 8278 -4609 111 8282 8280 8281 -4610 111 8285 8283 8284 -4611 111 8288 8286 8287 -4612 111 8291 8289 8290 -4613 111 8294 8292 8293 -4614 111 8297 8295 8296 -4615 111 8300 8298 8299 -4616 111 8303 8301 8302 -4617 111 8306 8304 8305 -4618 111 8309 8307 8308 -4619 111 8312 8310 8311 -4620 111 8315 8313 8314 -4621 111 8318 8316 8317 -4622 111 8321 8319 8320 -4623 111 8324 8322 8323 -4624 111 8327 8325 8326 -4625 111 8330 8328 8329 -4626 111 8333 8331 8332 -4627 111 8336 8334 8335 -4628 111 8339 8337 8338 -4629 111 8342 8340 8341 -4630 111 8345 8343 8344 -4631 111 8348 8346 8347 -4632 111 8351 8349 8350 -4633 111 8354 8352 8353 -4634 111 8357 8355 8356 -4635 111 8360 8358 8359 -4636 111 8363 8361 8362 -4637 111 8366 8364 8365 -4638 111 8369 8367 8368 -4639 111 8372 8370 8371 -4640 111 8375 8373 8374 -4641 111 8378 8376 8377 -4642 111 8381 8379 8380 -4643 111 8384 8382 8383 -4644 111 8387 8385 8386 -4645 111 8390 8388 8389 -4646 111 8393 8391 8392 -4647 111 8396 8394 8395 -4648 111 8399 8397 8398 -4649 111 8402 8400 8401 -4650 111 8405 8403 8404 -4651 111 8408 8406 8407 -4652 111 8411 8409 8410 -4653 111 8414 8412 8413 -4654 111 8417 8415 8416 -4655 111 8420 8418 8419 -4656 111 8423 8421 8422 -4657 111 8426 8424 8425 -4658 111 8429 8427 8428 -4659 111 8432 8430 8431 -4660 111 8435 8433 8434 -4661 111 8438 8436 8437 -4662 111 8441 8439 8440 -4663 111 8444 8442 8443 -4664 111 8447 8445 8446 -4665 111 8450 8448 8449 -4666 111 8453 8451 8452 -4667 111 8456 8454 8455 -4668 111 8459 8457 8458 -4669 111 8462 8460 8461 -4670 111 8465 8463 8464 -4671 111 8468 8466 8467 -4672 111 8471 8469 8470 -4673 111 8474 8472 8473 -4674 111 8477 8475 8476 -4675 111 8480 8478 8479 -4676 111 8483 8481 8482 -4677 111 8486 8484 8485 -4678 111 8489 8487 8488 -4679 111 8492 8490 8491 -4680 111 8495 8493 8494 -4681 111 8498 8496 8497 -4682 111 8501 8499 8500 -4683 111 8504 8502 8503 -4684 111 8507 8505 8506 -4685 111 8510 8508 8509 -4686 111 8513 8511 8512 -4687 111 8516 8514 8515 -4688 111 8519 8517 8518 -4689 111 8522 8520 8521 -4690 111 8525 8523 8524 -4691 111 8528 8526 8527 -4692 111 8531 8529 8530 -4693 111 8534 8532 8533 -4694 111 8537 8535 8536 -4695 111 8540 8538 8539 -4696 111 8543 8541 8542 -4697 111 8546 8544 8545 -4698 111 8549 8547 8548 -4699 111 8552 8550 8551 -4700 111 8555 8553 8554 -4701 111 8558 8556 8557 -4702 111 8561 8559 8560 -4703 111 8564 8562 8563 -4704 111 8567 8565 8566 -4705 111 8570 8568 8569 -4706 111 8573 8571 8572 -4707 111 8576 8574 8575 -4708 111 8579 8577 8578 -4709 111 8582 8580 8581 -4710 111 8585 8583 8584 -4711 111 8588 8586 8587 -4712 111 8591 8589 8590 -4713 111 8594 8592 8593 -4714 111 8597 8595 8596 -4715 111 8600 8598 8599 -4716 111 8603 8601 8602 -4717 111 8606 8604 8605 -4718 111 8609 8607 8608 -4719 111 8612 8610 8611 -4720 111 8615 8613 8614 -4721 111 8618 8616 8617 -4722 111 8621 8619 8620 -4723 111 8624 8622 8623 -4724 111 8627 8625 8626 -4725 111 8630 8628 8629 -4726 111 8633 8631 8632 -4727 111 8636 8634 8635 -4728 111 8639 8637 8638 -4729 111 8642 8640 8641 -4730 111 8645 8643 8644 -4731 111 8648 8646 8647 -4732 111 8651 8649 8650 -4733 111 8654 8652 8653 -4734 111 8657 8655 8656 -4735 111 8660 8658 8659 -4736 111 8663 8661 8662 -4737 111 8666 8664 8665 -4738 111 8669 8667 8668 -4739 111 8672 8670 8671 -4740 111 8675 8673 8674 -4741 111 8678 8676 8677 -4742 111 8681 8679 8680 -4743 111 8684 8682 8683 -4744 111 8687 8685 8686 -4745 111 8690 8688 8689 -4746 111 8693 8691 8692 -4747 111 8696 8694 8695 -4748 111 8699 8697 8698 -4749 111 8702 8700 8701 -4750 111 8705 8703 8704 -4751 111 8708 8706 8707 -4752 111 8711 8709 8710 -4753 111 8714 8712 8713 -4754 111 8717 8715 8716 -4755 111 8720 8718 8719 -4756 111 8723 8721 8722 -4757 111 8726 8724 8725 -4758 111 8729 8727 8728 -4759 111 8732 8730 8731 -4760 111 8735 8733 8734 -4761 111 8738 8736 8737 -4762 111 8741 8739 8740 -4763 111 8744 8742 8743 -4764 111 8747 8745 8746 -4765 111 8750 8748 8749 -4766 111 8753 8751 8752 -4767 111 8756 8754 8755 -4768 111 8759 8757 8758 -4769 111 8762 8760 8761 -4770 111 8765 8763 8764 -4771 111 8768 8766 8767 -4772 111 8771 8769 8770 -4773 111 8774 8772 8773 -4774 111 8777 8775 8776 -4775 111 8780 8778 8779 -4776 111 8783 8781 8782 -4777 111 8786 8784 8785 -4778 111 8789 8787 8788 -4779 111 8792 8790 8791 -4780 111 8795 8793 8794 -4781 111 8798 8796 8797 -4782 111 8801 8799 8800 -4783 111 8804 8802 8803 -4784 111 8807 8805 8806 -4785 111 8810 8808 8809 -4786 111 8813 8811 8812 -4787 111 8816 8814 8815 -4788 111 8819 8817 8818 -4789 111 8822 8820 8821 -4790 111 8825 8823 8824 -4791 111 8828 8826 8827 -4792 111 8831 8829 8830 -4793 111 8834 8832 8833 -4794 111 8837 8835 8836 -4795 111 8840 8838 8839 -4796 111 8843 8841 8842 -4797 111 8846 8844 8845 -4798 111 8849 8847 8848 -4799 111 8852 8850 8851 -4800 111 8855 8853 8854 -4801 111 8858 8856 8857 -4802 111 8861 8859 8860 -4803 111 8864 8862 8863 -4804 111 8867 8865 8866 -4805 111 8870 8868 8869 -4806 111 8873 8871 8872 -4807 111 8876 8874 8875 -4808 111 8879 8877 8878 -4809 111 8882 8880 8881 -4810 111 8885 8883 8884 -4811 111 8888 8886 8887 -4812 111 8891 8889 8890 -4813 111 8894 8892 8893 -4814 111 8897 8895 8896 -4815 111 8900 8898 8899 -4816 111 8903 8901 8902 -4817 111 8906 8904 8905 -4818 111 8909 8907 8908 -4819 111 8912 8910 8911 -4820 111 8915 8913 8914 -4821 111 8918 8916 8917 -4822 111 8921 8919 8920 -4823 111 8924 8922 8923 -4824 111 8927 8925 8926 -4825 111 8930 8928 8929 -4826 111 8933 8931 8932 -4827 111 8936 8934 8935 -4828 111 8939 8937 8938 -4829 111 8942 8940 8941 -4830 111 8945 8943 8944 -4831 111 8948 8946 8947 -4832 111 8951 8949 8950 -4833 111 8954 8952 8953 -4834 111 8957 8955 8956 -4835 111 8960 8958 8959 -4836 111 8963 8961 8962 -4837 111 8966 8964 8965 -4838 111 8969 8967 8968 -4839 111 8972 8970 8971 -4840 111 8975 8973 8974 -4841 111 8978 8976 8977 -4842 111 8981 8979 8980 -4843 111 8984 8982 8983 -4844 111 8987 8985 8986 -4845 111 8990 8988 8989 -4846 111 8993 8991 8992 -4847 111 8996 8994 8995 -4848 111 8999 8997 8998 -4849 111 9002 9000 9001 -4850 111 9005 9003 9004 -4851 111 9008 9006 9007 -4852 111 9011 9009 9010 -4853 111 9014 9012 9013 -4854 111 9017 9015 9016 -4855 111 9020 9018 9019 -4856 111 9023 9021 9022 -4857 111 9026 9024 9025 -4858 111 9029 9027 9028 -4859 111 9032 9030 9031 -4860 111 9035 9033 9034 -4861 111 9038 9036 9037 -4862 111 9041 9039 9040 -4863 111 9044 9042 9043 -4864 111 9047 9045 9046 -4865 111 9050 9048 9049 -4866 111 9053 9051 9052 -4867 111 9056 9054 9055 -4868 111 9059 9057 9058 -4869 111 9062 9060 9061 -4870 111 9065 9063 9064 -4871 111 9068 9066 9067 -4872 111 9071 9069 9070 -4873 111 9074 9072 9073 -4874 111 9077 9075 9076 -4875 111 9080 9078 9079 -4876 111 9083 9081 9082 -4877 111 9086 9084 9085 -4878 111 9089 9087 9088 -4879 111 9092 9090 9091 -4880 111 9095 9093 9094 -4881 111 9098 9096 9097 -4882 111 9101 9099 9100 -4883 111 9104 9102 9103 -4884 111 9107 9105 9106 -4885 111 9110 9108 9109 -4886 111 9113 9111 9112 -4887 111 9116 9114 9115 -4888 111 9119 9117 9118 -4889 111 9122 9120 9121 -4890 111 9125 9123 9124 -4891 111 9128 9126 9127 -4892 111 9131 9129 9130 -4893 111 9134 9132 9133 -4894 111 9137 9135 9136 -4895 111 9140 9138 9139 -4896 111 9143 9141 9142 -4897 111 9146 9144 9145 -4898 111 9149 9147 9148 -4899 111 9152 9150 9151 -4900 111 9155 9153 9154 -4901 111 9158 9156 9157 -4902 111 9161 9159 9160 -4903 111 9164 9162 9163 -4904 111 9167 9165 9166 -4905 111 9170 9168 9169 -4906 111 9173 9171 9172 -4907 111 9176 9174 9175 -4908 111 9179 9177 9178 -4909 111 9182 9180 9181 -4910 111 9185 9183 9184 -4911 111 9188 9186 9187 -4912 111 9191 9189 9190 -4913 111 9194 9192 9193 -4914 111 9197 9195 9196 -4915 111 9200 9198 9199 -4916 111 9203 9201 9202 -4917 111 9206 9204 9205 -4918 111 9209 9207 9208 -4919 111 9212 9210 9211 -4920 111 9215 9213 9214 -4921 111 9218 9216 9217 -4922 111 9221 9219 9220 -4923 111 9224 9222 9223 -4924 111 9227 9225 9226 -4925 111 9230 9228 9229 -4926 111 9233 9231 9232 -4927 111 9236 9234 9235 -4928 111 9239 9237 9238 -4929 111 9242 9240 9241 -4930 111 9245 9243 9244 -4931 111 9248 9246 9247 -4932 111 9251 9249 9250 -4933 111 9254 9252 9253 -4934 111 9257 9255 9256 -4935 111 9260 9258 9259 -4936 111 9263 9261 9262 -4937 111 9266 9264 9265 -4938 111 9269 9267 9268 -4939 111 9272 9270 9271 -4940 111 9275 9273 9274 -4941 111 9278 9276 9277 -4942 111 9281 9279 9280 -4943 111 9284 9282 9283 -4944 111 9287 9285 9286 -4945 111 9290 9288 9289 -4946 111 9293 9291 9292 -4947 111 9296 9294 9295 -4948 111 9299 9297 9298 -4949 111 9302 9300 9301 -4950 111 9305 9303 9304 -4951 111 9308 9306 9307 -4952 111 9311 9309 9310 -4953 111 9314 9312 9313 -4954 111 9317 9315 9316 -4955 111 9320 9318 9319 -4956 111 9323 9321 9322 -4957 111 9326 9324 9325 -4958 111 9329 9327 9328 -4959 111 9332 9330 9331 -4960 111 9335 9333 9334 -4961 111 9338 9336 9337 -4962 111 9341 9339 9340 -4963 111 9344 9342 9343 -4964 111 9347 9345 9346 -4965 111 9350 9348 9349 -4966 111 9353 9351 9352 -4967 111 9356 9354 9355 -4968 111 9359 9357 9358 -4969 111 9362 9360 9361 -4970 111 9365 9363 9364 -4971 111 9368 9366 9367 -4972 111 9371 9369 9370 -4973 111 9374 9372 9373 -4974 111 9377 9375 9376 -4975 111 9380 9378 9379 -4976 111 9383 9381 9382 -4977 111 9386 9384 9385 -4978 111 9389 9387 9388 -4979 111 9392 9390 9391 -4980 111 9395 9393 9394 -4981 111 9398 9396 9397 -4982 111 9401 9399 9400 -4983 111 9404 9402 9403 -4984 111 9407 9405 9406 -4985 111 9410 9408 9409 -4986 111 9413 9411 9412 -4987 111 9416 9414 9415 -4988 111 9419 9417 9418 -4989 111 9422 9420 9421 -4990 111 9425 9423 9424 -4991 111 9428 9426 9427 -4992 111 9431 9429 9430 -4993 111 9434 9432 9433 -4994 111 9437 9435 9436 -4995 111 9440 9438 9439 -4996 111 9443 9441 9442 -4997 111 9446 9444 9445 -4998 111 9449 9447 9448 -4999 111 9452 9450 9451 -5000 111 9455 9453 9454 -5001 111 9458 9456 9457 -5002 111 9461 9459 9460 -5003 111 9464 9462 9463 -5004 111 9467 9465 9466 -5005 111 9470 9468 9469 -5006 111 9473 9471 9472 -5007 111 9476 9474 9475 -5008 111 9479 9477 9478 -5009 111 9482 9480 9481 -5010 111 9485 9483 9484 -5011 111 9488 9486 9487 -5012 111 9491 9489 9490 -5013 111 9494 9492 9493 -5014 111 9497 9495 9496 -5015 111 9500 9498 9499 -5016 111 9503 9501 9502 -5017 111 9506 9504 9505 -5018 111 9509 9507 9508 -5019 111 9512 9510 9511 -5020 111 9515 9513 9514 -5021 111 9518 9516 9517 -5022 111 9521 9519 9520 -5023 111 9524 9522 9523 -5024 111 9527 9525 9526 -5025 111 9530 9528 9529 -5026 111 9533 9531 9532 -5027 111 9536 9534 9535 -5028 111 9539 9537 9538 -5029 111 9542 9540 9541 -5030 111 9545 9543 9544 -5031 111 9548 9546 9547 -5032 111 9551 9549 9550 -5033 111 9554 9552 9553 -5034 111 9557 9555 9556 -5035 111 9560 9558 9559 -5036 111 9563 9561 9562 -5037 111 9566 9564 9565 -5038 111 9569 9567 9568 -5039 111 9572 9570 9571 -5040 111 9575 9573 9574 -5041 111 9578 9576 9577 -5042 111 9581 9579 9580 -5043 111 9584 9582 9583 -5044 111 9587 9585 9586 -5045 111 9590 9588 9589 -5046 111 9593 9591 9592 -5047 111 9596 9594 9595 -5048 111 9599 9597 9598 -5049 111 9602 9600 9601 -5050 111 9605 9603 9604 -5051 111 9608 9606 9607 -5052 111 9611 9609 9610 -5053 111 9614 9612 9613 -5054 111 9617 9615 9616 -5055 111 9620 9618 9619 -5056 111 9623 9621 9622 -5057 111 9626 9624 9625 -5058 111 9629 9627 9628 -5059 111 9632 9630 9631 -5060 111 9635 9633 9634 -5061 111 9638 9636 9637 -5062 111 9641 9639 9640 -5063 111 9644 9642 9643 -5064 111 9647 9645 9646 -5065 111 9650 9648 9649 -5066 111 9653 9651 9652 -5067 111 9656 9654 9655 -5068 111 9659 9657 9658 -5069 111 9662 9660 9661 -5070 111 9665 9663 9664 -5071 111 9668 9666 9667 -5072 111 9671 9669 9670 -5073 111 9674 9672 9673 -5074 111 9677 9675 9676 -5075 111 9680 9678 9679 -5076 111 9683 9681 9682 -5077 111 9686 9684 9685 -5078 111 9689 9687 9688 -5079 111 9692 9690 9691 -5080 111 9695 9693 9694 -5081 111 9698 9696 9697 -5082 111 9701 9699 9700 -5083 111 9704 9702 9703 -5084 111 9707 9705 9706 -5085 111 9710 9708 9709 -5086 111 9713 9711 9712 -5087 111 9716 9714 9715 -5088 111 9719 9717 9718 -5089 111 9722 9720 9721 -5090 111 9725 9723 9724 -5091 111 9728 9726 9727 -5092 111 9731 9729 9730 -5093 111 9734 9732 9733 -5094 111 9737 9735 9736 - -Dihedrals - -1 1 5 1 2 3 -2 2 5 1 2 8 -3 3 5 1 2 9 -4 1 6 1 2 3 -5 2 6 1 2 8 -6 3 6 1 2 9 -7 1 7 1 2 3 -8 2 7 1 2 8 -9 3 7 1 2 9 -10 4 1 2 3 4 -11 5 1 2 3 20 -12 6 1 2 9 10 -13 7 1 2 9 13 -14 7 1 2 9 14 -15 8 3 2 9 10 -16 9 3 2 9 13 -17 9 3 2 9 14 -18 10 8 2 3 4 -19 11 8 2 3 20 -20 12 8 2 9 10 -21 13 8 2 9 13 -22 13 8 2 9 14 -23 14 9 2 3 4 -24 15 9 2 3 20 -25 16 2 3 20 21 -26 17 2 3 20 24 -27 18 4 3 20 21 -28 19 4 3 20 24 -29 20 2 9 10 11 -30 21 2 9 10 15 -31 21 2 9 10 16 -32 22 13 9 10 11 -33 23 13 9 10 15 -34 23 13 9 10 16 -35 22 14 9 10 11 -36 23 14 9 10 15 -37 23 14 9 10 16 -38 24 9 10 11 12 -39 25 15 10 11 12 -40 25 16 10 11 12 -41 25 10 11 12 17 -42 25 10 11 12 18 -43 25 10 11 12 19 -44 26 3 20 21 22 -45 27 3 20 21 25 -46 28 3 20 21 26 -47 29 24 20 21 22 -48 30 24 20 21 25 -49 31 24 20 21 26 -50 32 20 21 22 23 -51 33 20 21 22 37 -52 34 20 21 26 27 -53 35 20 21 26 31 -54 35 20 21 26 32 -55 8 22 21 26 27 -56 9 22 21 26 31 -57 9 22 21 26 32 -58 10 25 21 22 23 -59 11 25 21 22 37 -60 12 25 21 26 27 -61 13 25 21 26 31 -62 13 25 21 26 32 -63 14 26 21 22 23 -64 15 26 21 22 37 -65 16 21 22 37 38 -66 17 21 22 37 41 -67 18 23 22 37 38 -68 19 23 22 37 41 -69 36 21 26 27 28 -70 21 21 26 27 33 -71 21 21 26 27 34 -72 37 31 26 27 28 -73 23 31 26 27 33 -74 23 31 26 27 34 -75 37 32 26 27 28 -76 23 32 26 27 33 -77 23 32 26 27 34 -78 38 26 27 28 29 -79 39 26 27 28 30 -80 40 33 27 28 29 -81 41 33 27 28 30 -82 40 34 27 28 29 -83 41 34 27 28 30 -84 42 27 28 30 35 -85 42 27 28 30 36 -86 19 29 28 30 35 -87 19 29 28 30 36 -88 26 22 37 38 39 -89 27 22 37 38 42 -90 43 22 37 38 43 -91 29 41 37 38 39 -92 30 41 37 38 42 -93 44 41 37 38 43 -94 32 37 38 39 40 -95 33 37 38 39 56 -96 45 37 38 43 44 -97 45 37 38 43 45 -98 46 37 38 43 47 -99 47 39 38 43 44 -100 47 39 38 43 45 -101 48 39 38 43 47 -102 10 42 38 39 40 -103 11 42 38 39 56 -104 49 42 38 43 44 -105 49 42 38 43 45 -106 50 42 38 43 47 -107 51 43 38 39 40 -108 52 43 38 39 56 -109 16 38 39 56 57 -110 17 38 39 56 60 -111 18 40 39 56 57 -112 19 40 39 56 60 -113 53 38 43 44 46 -114 54 38 43 44 48 -115 54 38 43 44 49 -116 54 38 43 45 50 -117 54 38 43 45 51 -118 54 38 43 45 52 -119 55 44 43 45 50 -120 55 44 43 45 51 -121 55 44 43 45 52 -122 56 45 43 44 46 -123 55 45 43 44 48 -124 55 45 43 44 49 -125 12 47 43 44 46 -126 13 47 43 44 48 -127 13 47 43 44 49 -128 13 47 43 45 50 -129 13 47 43 45 51 -130 13 47 43 45 52 -131 21 43 44 46 53 -132 21 43 44 46 54 -133 21 43 44 46 55 -134 23 48 44 46 53 -135 23 48 44 46 54 -136 23 48 44 46 55 -137 23 49 44 46 53 -138 23 49 44 46 54 -139 23 49 44 46 55 -140 26 39 56 57 58 -141 27 39 56 57 61 -142 28 39 56 57 62 -143 29 60 56 57 58 -144 30 60 56 57 61 -145 31 60 56 57 62 -146 32 56 57 58 59 -147 33 56 57 58 76 -148 57 56 57 62 63 -149 35 56 57 62 69 -150 35 56 57 62 70 -151 58 58 57 62 63 -152 9 58 57 62 69 -153 9 58 57 62 70 -154 10 61 57 58 59 -155 11 61 57 58 76 -156 59 61 57 62 63 -157 13 61 57 62 69 -158 13 61 57 62 70 -159 14 62 57 58 59 -160 15 62 57 58 76 -161 16 57 58 76 77 -162 17 57 58 76 80 -163 18 59 58 76 77 -164 19 59 58 76 80 -165 60 57 62 63 64 -166 60 57 62 63 65 -167 61 69 62 63 64 -168 61 69 62 63 65 -169 61 70 62 63 64 -170 61 70 62 63 65 -171 62 62 63 64 66 -172 63 62 63 64 71 -173 62 62 63 65 67 -174 63 62 63 65 72 -175 64 64 63 65 67 -176 65 64 63 65 72 -177 64 65 63 64 66 -178 65 65 63 64 71 -179 64 63 64 66 68 -180 65 63 64 66 73 -181 65 71 64 66 68 -182 66 71 64 66 73 -183 64 63 65 67 68 -184 65 63 65 67 74 -185 65 72 65 67 68 -186 66 72 65 67 74 -187 64 64 66 68 67 -188 65 64 66 68 75 -189 65 73 66 68 67 -190 66 73 66 68 75 -191 64 65 67 68 66 -192 65 65 67 68 75 -193 65 74 67 68 66 -194 66 74 67 68 75 -195 26 58 76 77 78 -196 27 58 76 77 81 -197 43 58 76 77 82 -198 29 80 76 77 78 -199 30 80 76 77 81 -200 44 80 76 77 82 -201 32 76 77 78 79 -202 33 76 77 78 92 -203 45 76 77 82 83 -204 45 76 77 82 84 -205 46 76 77 82 85 -206 47 78 77 82 83 -207 47 78 77 82 84 -208 48 78 77 82 85 -209 10 81 77 78 79 -210 11 81 77 78 92 -211 49 81 77 82 83 -212 49 81 77 82 84 -213 50 81 77 82 85 -214 51 82 77 78 79 -215 52 82 77 78 92 -216 16 77 78 92 93 -217 17 77 78 92 96 -218 18 79 78 92 93 -219 19 79 78 92 96 -220 54 77 82 83 86 -221 54 77 82 83 87 -222 54 77 82 83 88 -223 54 77 82 84 89 -224 54 77 82 84 90 -225 54 77 82 84 91 -226 55 83 82 84 89 -227 55 83 82 84 90 -228 55 83 82 84 91 -229 55 84 82 83 86 -230 55 84 82 83 87 -231 55 84 82 83 88 -232 13 85 82 83 86 -233 13 85 82 83 87 -234 13 85 82 83 88 -235 13 85 82 84 89 -236 13 85 82 84 90 -237 13 85 82 84 91 -238 26 78 92 93 94 -239 27 78 92 93 97 -240 28 78 92 93 98 -241 29 96 92 93 94 -242 30 96 92 93 97 -243 31 96 92 93 98 -244 32 92 93 94 95 -245 33 92 93 94 114 -246 34 92 93 98 99 -247 35 92 93 98 103 -248 35 92 93 98 104 -249 8 94 93 98 99 -250 9 94 93 98 103 -251 9 94 93 98 104 -252 10 97 93 94 95 -253 11 97 93 94 114 -254 12 97 93 98 99 -255 13 97 93 98 103 -256 13 97 93 98 104 -257 14 98 93 94 95 -258 15 98 93 94 114 -259 16 93 94 114 115 -260 17 93 94 114 118 -261 18 95 94 114 115 -262 19 95 94 114 118 -263 67 93 98 99 100 -264 21 93 98 99 105 -265 21 93 98 99 106 -266 68 103 98 99 100 -267 23 103 98 99 105 -268 23 103 98 99 106 -269 68 104 98 99 100 -270 23 104 98 99 105 -271 23 104 98 99 106 -272 69 98 99 100 101 -273 68 98 99 100 107 -274 68 98 99 100 108 -275 68 105 99 100 101 -276 23 105 99 100 107 -277 23 105 99 100 108 -278 68 106 99 100 101 -279 23 106 99 100 107 -280 23 106 99 100 108 -281 70 99 100 101 102 -282 68 99 100 101 109 -283 68 99 100 101 110 -284 71 107 100 101 102 -285 23 107 100 101 109 -286 23 107 100 101 110 -287 71 108 100 101 102 -288 23 108 100 101 109 -289 23 108 100 101 110 -290 72 100 101 102 111 -291 72 100 101 102 112 -292 72 100 101 102 113 -293 73 109 101 102 111 -294 73 109 101 102 112 -295 73 109 101 102 113 -296 73 110 101 102 111 -297 73 110 101 102 112 -298 73 110 101 102 113 -299 26 94 114 115 116 -300 27 94 114 115 119 -301 43 94 114 115 120 -302 29 118 114 115 116 -303 30 118 114 115 119 -304 44 118 114 115 120 -305 32 114 115 116 117 -306 33 114 115 116 128 -307 74 114 115 120 121 -308 45 114 115 120 122 -309 46 114 115 120 123 -310 75 116 115 120 121 -311 47 116 115 120 122 -312 48 116 115 120 123 -313 10 119 115 116 117 -314 11 119 115 116 128 -315 76 119 115 120 121 -316 49 119 115 120 122 -317 50 119 115 120 123 -318 51 120 115 116 117 -319 52 120 115 116 128 -320 16 115 116 128 129 -321 17 115 116 128 132 -322 18 117 116 128 129 -323 19 117 116 128 132 -324 77 115 120 121 124 -325 54 115 120 122 125 -326 54 115 120 122 126 -327 54 115 120 122 127 -328 78 121 120 122 125 -329 78 121 120 122 126 -330 78 121 120 122 127 -331 79 122 120 121 124 -332 80 123 120 121 124 -333 13 123 120 122 125 -334 13 123 120 122 126 -335 13 123 120 122 127 -336 26 116 128 129 130 -337 27 116 128 129 133 -338 28 116 128 129 134 -339 29 132 128 129 130 -340 30 132 128 129 133 -341 31 132 128 129 134 -342 32 128 129 130 131 -343 33 128 129 130 147 -344 81 128 129 134 135 -345 35 128 129 134 138 -346 35 128 129 134 139 -347 82 130 129 134 135 -348 9 130 129 134 138 -349 9 130 129 134 139 -350 10 133 129 130 131 -351 11 133 129 130 147 -352 83 133 129 134 135 -353 13 133 129 134 138 -354 13 133 129 134 139 -355 14 134 129 130 131 -356 15 134 129 130 147 -357 16 129 130 147 148 -358 17 129 130 147 151 -359 18 131 130 147 148 -360 19 131 130 147 151 -361 84 129 134 135 136 -362 84 129 134 135 137 -363 83 129 134 135 140 -364 55 138 134 135 136 -365 55 138 134 135 137 -366 13 138 134 135 140 -367 55 139 134 135 136 -368 55 139 134 135 137 -369 13 139 134 135 140 -370 55 134 135 136 141 -371 55 134 135 136 142 -372 55 134 135 136 143 -373 55 134 135 137 144 -374 55 134 135 137 145 -375 55 134 135 137 146 -376 55 136 135 137 144 -377 55 136 135 137 145 -378 55 136 135 137 146 -379 55 137 135 136 141 -380 55 137 135 136 142 -381 55 137 135 136 143 -382 13 140 135 136 141 -383 13 140 135 136 142 -384 13 140 135 136 143 -385 13 140 135 137 144 -386 13 140 135 137 145 -387 13 140 135 137 146 -388 26 130 147 148 149 -389 27 130 147 148 152 -390 43 130 147 148 153 -391 29 151 147 148 149 -392 30 151 147 148 152 -393 44 151 147 148 153 -394 32 147 148 149 150 -395 33 147 148 149 161 -396 74 147 148 153 154 -397 45 147 148 153 155 -398 46 147 148 153 156 -399 75 149 148 153 154 -400 47 149 148 153 155 -401 48 149 148 153 156 -402 10 152 148 149 150 -403 11 152 148 149 161 -404 76 152 148 153 154 -405 49 152 148 153 155 -406 50 152 148 153 156 -407 51 153 148 149 150 -408 52 153 148 149 161 -409 85 148 149 161 162 -410 17 148 149 161 165 -411 86 150 149 161 162 -412 19 150 149 161 165 -413 77 148 153 154 157 -414 54 148 153 155 158 -415 54 148 153 155 159 -416 54 148 153 155 160 -417 78 154 153 155 158 -418 78 154 153 155 159 -419 78 154 153 155 160 -420 79 155 153 154 157 -421 80 156 153 154 157 -422 13 156 153 155 158 -423 13 156 153 155 159 -424 13 156 153 155 160 -425 87 149 161 162 163 -426 88 149 161 162 166 -427 88 149 161 162 167 -428 89 165 161 162 163 -429 90 165 161 162 166 -430 90 165 161 162 167 -431 91 161 162 163 164 -432 92 161 162 163 168 -433 93 166 162 163 164 -434 94 166 162 163 168 -435 93 167 162 163 164 -436 94 167 162 163 168 -437 95 162 163 168 169 -438 96 162 163 168 172 -439 18 164 163 168 169 -440 19 164 163 168 172 -441 26 163 168 169 170 -442 27 163 168 169 173 -443 28 163 168 169 174 -444 29 172 168 169 170 -445 30 172 168 169 173 -446 31 172 168 169 174 -447 32 168 169 170 171 -448 33 168 169 170 190 -449 34 168 169 174 175 -450 35 168 169 174 179 -451 35 168 169 174 180 -452 8 170 169 174 175 -453 9 170 169 174 179 -454 9 170 169 174 180 -455 10 173 169 170 171 -456 11 173 169 170 190 -457 12 173 169 174 175 -458 13 173 169 174 179 -459 13 173 169 174 180 -460 14 174 169 170 171 -461 15 174 169 170 190 -462 16 169 170 190 191 -463 17 169 170 190 194 -464 18 171 170 190 191 -465 19 171 170 190 194 -466 67 169 174 175 176 -467 21 169 174 175 181 -468 21 169 174 175 182 -469 68 179 174 175 176 -470 23 179 174 175 181 -471 23 179 174 175 182 -472 68 180 174 175 176 -473 23 180 174 175 181 -474 23 180 174 175 182 -475 69 174 175 176 177 -476 68 174 175 176 183 -477 68 174 175 176 184 -478 68 181 175 176 177 -479 23 181 175 176 183 -480 23 181 175 176 184 -481 68 182 175 176 177 -482 23 182 175 176 183 -483 23 182 175 176 184 -484 70 175 176 177 178 -485 68 175 176 177 185 -486 68 175 176 177 186 -487 71 183 176 177 178 -488 23 183 176 177 185 -489 23 183 176 177 186 -490 71 184 176 177 178 -491 23 184 176 177 185 -492 23 184 176 177 186 -493 72 176 177 178 187 -494 72 176 177 178 188 -495 72 176 177 178 189 -496 73 185 177 178 187 -497 73 185 177 178 188 -498 73 185 177 178 189 -499 73 186 177 178 187 -500 73 186 177 178 188 -501 73 186 177 178 189 -502 26 170 190 191 192 -503 27 170 190 191 195 -504 43 170 190 191 196 -505 29 194 190 191 192 -506 30 194 190 191 195 -507 44 194 190 191 196 -508 32 190 191 192 193 -509 33 190 191 192 204 -510 74 190 191 196 197 -511 45 190 191 196 198 -512 46 190 191 196 199 -513 75 192 191 196 197 -514 47 192 191 196 198 -515 48 192 191 196 199 -516 10 195 191 192 193 -517 11 195 191 192 204 -518 76 195 191 196 197 -519 49 195 191 196 198 -520 50 195 191 196 199 -521 51 196 191 192 193 -522 52 196 191 192 204 -523 16 191 192 204 205 -524 17 191 192 204 208 -525 18 193 192 204 205 -526 19 193 192 204 208 -527 77 191 196 197 200 -528 54 191 196 198 201 -529 54 191 196 198 202 -530 54 191 196 198 203 -531 78 197 196 198 201 -532 78 197 196 198 202 -533 78 197 196 198 203 -534 79 198 196 197 200 -535 80 199 196 197 200 -536 13 199 196 198 201 -537 13 199 196 198 202 -538 13 199 196 198 203 -539 26 192 204 205 206 -540 27 192 204 205 209 -541 43 192 204 205 210 -542 29 208 204 205 206 -543 30 208 204 205 209 -544 44 208 204 205 210 -545 32 204 205 206 207 -546 33 204 205 206 223 -547 45 204 205 210 211 -548 45 204 205 210 212 -549 46 204 205 210 214 -550 47 206 205 210 211 -551 47 206 205 210 212 -552 48 206 205 210 214 -553 10 209 205 206 207 -554 11 209 205 206 223 -555 49 209 205 210 211 -556 49 209 205 210 212 -557 50 209 205 210 214 -558 51 210 205 206 207 -559 52 210 205 206 223 -560 16 205 206 223 224 -561 17 205 206 223 227 -562 18 207 206 223 224 -563 19 207 206 223 227 -564 53 205 210 211 213 -565 54 205 210 211 215 -566 54 205 210 211 216 -567 54 205 210 212 217 -568 54 205 210 212 218 -569 54 205 210 212 219 -570 55 211 210 212 217 -571 55 211 210 212 218 -572 55 211 210 212 219 -573 56 212 210 211 213 -574 55 212 210 211 215 -575 55 212 210 211 216 -576 12 214 210 211 213 -577 13 214 210 211 215 -578 13 214 210 211 216 -579 13 214 210 212 217 -580 13 214 210 212 218 -581 13 214 210 212 219 -582 21 210 211 213 220 -583 21 210 211 213 221 -584 21 210 211 213 222 -585 23 215 211 213 220 -586 23 215 211 213 221 -587 23 215 211 213 222 -588 23 216 211 213 220 -589 23 216 211 213 221 -590 23 216 211 213 222 -591 26 206 223 224 225 -592 27 206 223 224 228 -593 43 206 223 224 229 -594 29 227 223 224 225 -595 30 227 223 224 228 -596 44 227 223 224 229 -597 32 223 224 225 226 -598 33 223 224 225 237 -599 74 223 224 229 230 -600 45 223 224 229 231 -601 46 223 224 229 232 -602 75 225 224 229 230 -603 47 225 224 229 231 -604 48 225 224 229 232 -605 10 228 224 225 226 -606 11 228 224 225 237 -607 76 228 224 229 230 -608 49 228 224 229 231 -609 50 228 224 229 232 -610 51 229 224 225 226 -611 52 229 224 225 237 -612 16 224 225 237 238 -613 17 224 225 237 241 -614 18 226 225 237 238 -615 19 226 225 237 241 -616 77 224 229 230 233 -617 54 224 229 231 234 -618 54 224 229 231 235 -619 54 224 229 231 236 -620 78 230 229 231 234 -621 78 230 229 231 235 -622 78 230 229 231 236 -623 79 231 229 230 233 -624 80 232 229 230 233 -625 13 232 229 231 234 -626 13 232 229 231 235 -627 13 232 229 231 236 -628 26 225 237 238 239 -629 27 225 237 238 242 -630 28 225 237 238 243 -631 29 241 237 238 239 -632 30 241 237 238 242 -633 31 241 237 238 243 -634 32 237 238 239 240 -635 33 237 238 239 256 -636 81 237 238 243 244 -637 35 237 238 243 247 -638 35 237 238 243 248 -639 82 239 238 243 244 -640 9 239 238 243 247 -641 9 239 238 243 248 -642 10 242 238 239 240 -643 11 242 238 239 256 -644 83 242 238 243 244 -645 13 242 238 243 247 -646 13 242 238 243 248 -647 14 243 238 239 240 -648 15 243 238 239 256 -649 16 238 239 256 257 -650 17 238 239 256 260 -651 18 240 239 256 257 -652 19 240 239 256 260 -653 84 238 243 244 245 -654 84 238 243 244 246 -655 83 238 243 244 249 -656 55 247 243 244 245 -657 55 247 243 244 246 -658 13 247 243 244 249 -659 55 248 243 244 245 -660 55 248 243 244 246 -661 13 248 243 244 249 -662 55 243 244 245 250 -663 55 243 244 245 251 -664 55 243 244 245 252 -665 55 243 244 246 253 -666 55 243 244 246 254 -667 55 243 244 246 255 -668 55 245 244 246 253 -669 55 245 244 246 254 -670 55 245 244 246 255 -671 55 246 244 245 250 -672 55 246 244 245 251 -673 55 246 244 245 252 -674 13 249 244 245 250 -675 13 249 244 245 251 -676 13 249 244 245 252 -677 13 249 244 246 253 -678 13 249 244 246 254 -679 13 249 244 246 255 -680 26 239 256 257 258 -681 27 239 256 257 261 -682 28 239 256 257 262 -683 29 260 256 257 258 -684 30 260 256 257 261 -685 31 260 256 257 262 -686 32 256 257 258 259 -687 33 256 257 258 271 -688 34 256 257 262 263 -689 35 256 257 262 267 -690 35 256 257 262 268 -691 8 258 257 262 263 -692 9 258 257 262 267 -693 9 258 257 262 268 -694 10 261 257 258 259 -695 11 261 257 258 271 -696 12 261 257 262 263 -697 13 261 257 262 267 -698 13 261 257 262 268 -699 14 262 257 258 259 -700 15 262 257 258 271 -701 16 257 258 271 272 -702 17 257 258 271 275 -703 18 259 258 271 272 -704 19 259 258 271 275 -705 97 257 262 263 264 -706 21 257 262 263 269 -707 21 257 262 263 270 -708 98 267 262 263 264 -709 23 267 262 263 269 -710 23 267 262 263 270 -711 98 268 262 263 264 -712 23 268 262 263 269 -713 23 268 262 263 270 -714 99 262 263 264 265 -715 99 262 263 264 266 -716 100 269 263 264 265 -717 100 269 263 264 266 -718 100 270 263 264 265 -719 100 270 263 264 266 -720 26 258 271 272 273 -721 27 258 271 272 276 -722 43 258 271 272 277 -723 29 275 271 272 273 -724 30 275 271 272 276 -725 44 275 271 272 277 -726 32 271 272 273 274 -727 33 271 272 273 287 -728 45 271 272 277 278 -729 45 271 272 277 279 -730 46 271 272 277 280 -731 47 273 272 277 278 -732 47 273 272 277 279 -733 48 273 272 277 280 -734 10 276 272 273 274 -735 11 276 272 273 287 -736 49 276 272 277 278 -737 49 276 272 277 279 -738 50 276 272 277 280 -739 51 277 272 273 274 -740 52 277 272 273 287 -741 16 272 273 287 288 -742 17 272 273 287 291 -743 18 274 273 287 288 -744 19 274 273 287 291 -745 54 272 277 278 281 -746 54 272 277 278 282 -747 54 272 277 278 283 -748 54 272 277 279 284 -749 54 272 277 279 285 -750 54 272 277 279 286 -751 55 278 277 279 284 -752 55 278 277 279 285 -753 55 278 277 279 286 -754 55 279 277 278 281 -755 55 279 277 278 282 -756 55 279 277 278 283 -757 13 280 277 278 281 -758 13 280 277 278 282 -759 13 280 277 278 283 -760 13 280 277 279 284 -761 13 280 277 279 285 -762 13 280 277 279 286 -763 26 273 287 288 289 -764 27 273 287 288 292 -765 28 273 287 288 293 -766 29 291 287 288 289 -767 30 291 287 288 292 -768 31 291 287 288 293 -769 32 287 288 289 290 -770 101 287 288 289 302 -771 34 287 288 293 294 -772 35 287 288 293 298 -773 35 287 288 293 299 -774 8 289 288 293 294 -775 9 289 288 293 298 -776 9 289 288 293 299 -777 10 292 288 289 290 -778 102 292 288 289 302 -779 12 292 288 293 294 -780 13 292 288 293 298 -781 13 292 288 293 299 -782 14 293 288 289 290 -783 103 293 288 289 302 -784 104 288 289 302 303 -785 105 288 289 302 309 -786 106 290 289 302 303 -787 107 290 289 302 309 -788 97 288 293 294 295 -789 21 288 293 294 300 -790 21 288 293 294 301 -791 98 298 293 294 295 -792 23 298 293 294 300 -793 23 298 293 294 301 -794 98 299 293 294 295 -795 23 299 293 294 300 -796 23 299 293 294 301 -797 99 293 294 295 296 -798 99 293 294 295 297 -799 100 300 294 295 296 -800 100 300 294 295 297 -801 100 301 294 295 296 -802 100 301 294 295 297 -803 108 289 302 303 304 -804 109 289 302 303 306 -805 110 289 302 303 307 -806 111 289 302 309 308 -807 112 289 302 309 314 -808 112 289 302 309 315 -809 113 303 302 309 308 -810 114 303 302 309 314 -811 114 303 302 309 315 -812 115 309 302 303 304 -813 116 309 302 303 306 -814 117 309 302 303 307 -815 118 302 303 304 305 -816 119 302 303 304 316 -817 120 302 303 307 308 -818 121 302 303 307 310 -819 121 302 303 307 311 -820 122 304 303 307 308 -821 123 304 303 307 310 -822 123 304 303 307 311 -823 10 306 303 304 305 -824 11 306 303 304 316 -825 124 306 303 307 308 -826 125 306 303 307 310 -827 125 306 303 307 311 -828 126 307 303 304 305 -829 127 307 303 304 316 -830 16 303 304 316 317 -831 17 303 304 316 320 -832 18 305 304 316 317 -833 19 305 304 316 320 -834 128 303 307 308 309 -835 129 303 307 308 312 -836 129 303 307 308 313 -837 130 310 307 308 309 -838 131 310 307 308 312 -839 131 310 307 308 313 -840 130 311 307 308 309 -841 131 311 307 308 312 -842 131 311 307 308 313 -843 132 307 308 309 302 -844 133 307 308 309 314 -845 133 307 308 309 315 -846 134 312 308 309 302 -847 135 312 308 309 314 -848 135 312 308 309 315 -849 134 313 308 309 302 -850 135 313 308 309 314 -851 135 313 308 309 315 -852 26 304 316 317 318 -853 27 304 316 317 321 -854 28 304 316 317 322 -855 29 320 316 317 318 -856 30 320 316 317 321 -857 31 320 316 317 322 -858 32 316 317 318 319 -859 33 316 317 318 327 -860 136 316 317 322 323 -861 35 316 317 322 324 -862 35 316 317 322 325 -863 137 318 317 322 323 -864 9 318 317 322 324 -865 9 318 317 322 325 -866 10 321 317 318 319 -867 11 321 317 318 327 -868 138 321 317 322 323 -869 13 321 317 322 324 -870 13 321 317 322 325 -871 14 322 317 318 319 -872 15 322 317 318 327 -873 16 317 318 327 328 -874 17 317 318 327 331 -875 18 319 318 327 328 -876 19 319 318 327 331 -877 139 317 322 323 326 -878 140 324 322 323 326 -879 140 325 322 323 326 -880 26 318 327 328 329 -881 27 318 327 328 332 -882 28 318 327 328 333 -883 29 331 327 328 329 -884 30 331 327 328 332 -885 31 331 327 328 333 -886 32 327 328 329 330 -887 33 327 328 329 339 -888 141 327 328 333 334 -889 35 327 328 333 337 -890 35 327 328 333 338 -891 142 329 328 333 334 -892 9 329 328 333 337 -893 9 329 328 333 338 -894 10 332 328 329 330 -895 11 332 328 329 339 -896 143 332 328 333 334 -897 13 332 328 333 337 -898 13 332 328 333 338 -899 14 333 328 329 330 -900 15 333 328 329 339 -901 16 328 329 339 340 -902 17 328 329 339 343 -903 18 330 329 339 340 -904 19 330 329 339 343 -905 144 328 333 334 335 -906 144 328 333 334 336 -907 100 337 333 334 335 -908 100 337 333 334 336 -909 100 338 333 334 335 -910 100 338 333 334 336 -911 26 329 339 340 341 -912 27 329 339 340 344 -913 43 329 339 340 345 -914 29 343 339 340 341 -915 30 343 339 340 344 -916 44 343 339 340 345 -917 32 339 340 341 342 -918 33 339 340 341 353 -919 74 339 340 345 346 -920 45 339 340 345 347 -921 46 339 340 345 348 -922 75 341 340 345 346 -923 47 341 340 345 347 -924 48 341 340 345 348 -925 10 344 340 341 342 -926 11 344 340 341 353 -927 76 344 340 345 346 -928 49 344 340 345 347 -929 50 344 340 345 348 -930 51 345 340 341 342 -931 52 345 340 341 353 -932 16 340 341 353 354 -933 17 340 341 353 357 -934 18 342 341 353 354 -935 19 342 341 353 357 -936 77 340 345 346 349 -937 54 340 345 347 350 -938 54 340 345 347 351 -939 54 340 345 347 352 -940 78 346 345 347 350 -941 78 346 345 347 351 -942 78 346 345 347 352 -943 79 347 345 346 349 -944 80 348 345 346 349 -945 13 348 345 347 350 -946 13 348 345 347 351 -947 13 348 345 347 352 -948 26 341 353 354 355 -949 27 341 353 354 358 -950 43 341 353 354 359 -951 29 357 353 354 355 -952 30 357 353 354 358 -953 44 357 353 354 359 -954 32 353 354 355 356 -955 33 353 354 355 372 -956 45 353 354 359 360 -957 45 353 354 359 361 -958 46 353 354 359 363 -959 47 355 354 359 360 -960 47 355 354 359 361 -961 48 355 354 359 363 -962 10 358 354 355 356 -963 11 358 354 355 372 -964 49 358 354 359 360 -965 49 358 354 359 361 -966 50 358 354 359 363 -967 51 359 354 355 356 -968 52 359 354 355 372 -969 16 354 355 372 373 -970 17 354 355 372 376 -971 18 356 355 372 373 -972 19 356 355 372 376 -973 53 354 359 360 362 -974 54 354 359 360 364 -975 54 354 359 360 365 -976 54 354 359 361 366 -977 54 354 359 361 367 -978 54 354 359 361 368 -979 55 360 359 361 366 -980 55 360 359 361 367 -981 55 360 359 361 368 -982 56 361 359 360 362 -983 55 361 359 360 364 -984 55 361 359 360 365 -985 12 363 359 360 362 -986 13 363 359 360 364 -987 13 363 359 360 365 -988 13 363 359 361 366 -989 13 363 359 361 367 -990 13 363 359 361 368 -991 21 359 360 362 369 -992 21 359 360 362 370 -993 21 359 360 362 371 -994 23 364 360 362 369 -995 23 364 360 362 370 -996 23 364 360 362 371 -997 23 365 360 362 369 -998 23 365 360 362 370 -999 23 365 360 362 371 -1000 26 355 372 373 374 -1001 27 355 372 373 377 -1002 28 355 372 373 378 -1003 29 376 372 373 374 -1004 30 376 372 373 377 -1005 31 376 372 373 378 -1006 32 372 373 374 375 -1007 33 372 373 374 387 -1008 34 372 373 378 379 -1009 35 372 373 378 383 -1010 35 372 373 378 384 -1011 8 374 373 378 379 -1012 9 374 373 378 383 -1013 9 374 373 378 384 -1014 10 377 373 374 375 -1015 11 377 373 374 387 -1016 12 377 373 378 379 -1017 13 377 373 378 383 -1018 13 377 373 378 384 -1019 14 378 373 374 375 -1020 15 378 373 374 387 -1021 16 373 374 387 388 -1022 17 373 374 387 391 -1023 18 375 374 387 388 -1024 19 375 374 387 391 -1025 97 373 378 379 380 -1026 21 373 378 379 385 -1027 21 373 378 379 386 -1028 98 383 378 379 380 -1029 23 383 378 379 385 -1030 23 383 378 379 386 -1031 98 384 378 379 380 -1032 23 384 378 379 385 -1033 23 384 378 379 386 -1034 99 378 379 380 381 -1035 99 378 379 380 382 -1036 100 385 379 380 381 -1037 100 385 379 380 382 -1038 100 386 379 380 381 -1039 100 386 379 380 382 -1040 26 374 387 388 389 -1041 27 374 387 388 392 -1042 28 374 387 388 393 -1043 29 391 387 388 389 -1044 30 391 387 388 392 -1045 31 391 387 388 393 -1046 32 387 388 389 390 -1047 33 387 388 389 401 -1048 145 387 388 393 394 -1049 35 387 388 393 397 -1050 35 387 388 393 398 -1051 146 389 388 393 394 -1052 9 389 388 393 397 -1053 9 389 388 393 398 -1054 10 392 388 389 390 -1055 11 392 388 389 401 -1056 147 392 388 393 394 -1057 13 392 388 393 397 -1058 13 392 388 393 398 -1059 14 393 388 389 390 -1060 15 393 388 389 401 -1061 16 388 389 401 402 -1062 17 388 389 401 405 -1063 18 390 389 401 402 -1064 19 390 389 401 405 -1065 148 388 393 394 395 -1066 149 388 393 394 396 -1067 40 397 393 394 395 -1068 41 397 393 394 396 -1069 40 398 393 394 395 -1070 41 398 393 394 396 -1071 42 393 394 396 399 -1072 42 393 394 396 400 -1073 19 395 394 396 399 -1074 19 395 394 396 400 -1075 26 389 401 402 403 -1076 27 389 401 402 406 -1077 43 389 401 402 407 -1078 29 405 401 402 403 -1079 30 405 401 402 406 -1080 44 405 401 402 407 -1081 32 401 402 403 404 -1082 33 401 402 403 417 -1083 45 401 402 407 408 -1084 45 401 402 407 409 -1085 46 401 402 407 410 -1086 47 403 402 407 408 -1087 47 403 402 407 409 -1088 48 403 402 407 410 -1089 10 406 402 403 404 -1090 11 406 402 403 417 -1091 49 406 402 407 408 -1092 49 406 402 407 409 -1093 50 406 402 407 410 -1094 51 407 402 403 404 -1095 52 407 402 403 417 -1096 16 402 403 417 418 -1097 17 402 403 417 421 -1098 18 404 403 417 418 -1099 19 404 403 417 421 -1100 54 402 407 408 411 -1101 54 402 407 408 412 -1102 54 402 407 408 413 -1103 54 402 407 409 414 -1104 54 402 407 409 415 -1105 54 402 407 409 416 -1106 55 408 407 409 414 -1107 55 408 407 409 415 -1108 55 408 407 409 416 -1109 55 409 407 408 411 -1110 55 409 407 408 412 -1111 55 409 407 408 413 -1112 13 410 407 408 411 -1113 13 410 407 408 412 -1114 13 410 407 408 413 -1115 13 410 407 409 414 -1116 13 410 407 409 415 -1117 13 410 407 409 416 -1118 26 403 417 418 419 -1119 27 403 417 418 422 -1120 28 403 417 418 423 -1121 29 421 417 418 419 -1122 30 421 417 418 422 -1123 31 421 417 418 423 -1124 32 417 418 419 420 -1125 33 417 418 419 439 -1126 34 417 418 423 424 -1127 35 417 418 423 428 -1128 35 417 418 423 429 -1129 8 419 418 423 424 -1130 9 419 418 423 428 -1131 9 419 418 423 429 -1132 10 422 418 419 420 -1133 11 422 418 419 439 -1134 12 422 418 423 424 -1135 13 422 418 423 428 -1136 13 422 418 423 429 -1137 14 423 418 419 420 -1138 15 423 418 419 439 -1139 16 418 419 439 440 -1140 17 418 419 439 443 -1141 18 420 419 439 440 -1142 19 420 419 439 443 -1143 67 418 423 424 425 -1144 21 418 423 424 430 -1145 21 418 423 424 431 -1146 68 428 423 424 425 -1147 23 428 423 424 430 -1148 23 428 423 424 431 -1149 68 429 423 424 425 -1150 23 429 423 424 430 -1151 23 429 423 424 431 -1152 69 423 424 425 426 -1153 68 423 424 425 432 -1154 68 423 424 425 433 -1155 68 430 424 425 426 -1156 23 430 424 425 432 -1157 23 430 424 425 433 -1158 68 431 424 425 426 -1159 23 431 424 425 432 -1160 23 431 424 425 433 -1161 70 424 425 426 427 -1162 68 424 425 426 434 -1163 68 424 425 426 435 -1164 71 432 425 426 427 -1165 23 432 425 426 434 -1166 23 432 425 426 435 -1167 71 433 425 426 427 -1168 23 433 425 426 434 -1169 23 433 425 426 435 -1170 72 425 426 427 436 -1171 72 425 426 427 437 -1172 72 425 426 427 438 -1173 73 434 426 427 436 -1174 73 434 426 427 437 -1175 73 434 426 427 438 -1176 73 435 426 427 436 -1177 73 435 426 427 437 -1178 73 435 426 427 438 -1179 26 419 439 440 441 -1180 27 419 439 440 444 -1181 28 419 439 440 445 -1182 29 443 439 440 441 -1183 30 443 439 440 444 -1184 31 443 439 440 445 -1185 32 439 440 441 442 -1186 33 439 440 441 449 -1187 35 439 440 445 446 -1188 35 439 440 445 447 -1189 35 439 440 445 448 -1190 9 441 440 445 446 -1191 9 441 440 445 447 -1192 9 441 440 445 448 -1193 10 444 440 441 442 -1194 11 444 440 441 449 -1195 13 444 440 445 446 -1196 13 444 440 445 447 -1197 13 444 440 445 448 -1198 14 445 440 441 442 -1199 15 445 440 441 449 -1200 16 440 441 449 450 -1201 17 440 441 449 453 -1202 18 442 441 449 450 -1203 19 442 441 449 453 -1204 26 441 449 450 451 -1205 27 441 449 450 454 -1206 28 441 449 450 455 -1207 29 453 449 450 451 -1208 30 453 449 450 454 -1209 31 453 449 450 455 -1210 32 449 450 451 452 -1211 33 449 450 451 471 -1212 34 449 450 455 456 -1213 35 449 450 455 460 -1214 35 449 450 455 461 -1215 8 451 450 455 456 -1216 9 451 450 455 460 -1217 9 451 450 455 461 -1218 10 454 450 451 452 -1219 11 454 450 451 471 -1220 12 454 450 455 456 -1221 13 454 450 455 460 -1222 13 454 450 455 461 -1223 14 455 450 451 452 -1224 15 455 450 451 471 -1225 16 450 451 471 472 -1226 17 450 451 471 475 -1227 18 452 451 471 472 -1228 19 452 451 471 475 -1229 67 450 455 456 457 -1230 21 450 455 456 462 -1231 21 450 455 456 463 -1232 68 460 455 456 457 -1233 23 460 455 456 462 -1234 23 460 455 456 463 -1235 68 461 455 456 457 -1236 23 461 455 456 462 -1237 23 461 455 456 463 -1238 69 455 456 457 458 -1239 68 455 456 457 464 -1240 68 455 456 457 465 -1241 68 462 456 457 458 -1242 23 462 456 457 464 -1243 23 462 456 457 465 -1244 68 463 456 457 458 -1245 23 463 456 457 464 -1246 23 463 456 457 465 -1247 70 456 457 458 459 -1248 68 456 457 458 466 -1249 68 456 457 458 467 -1250 71 464 457 458 459 -1251 23 464 457 458 466 -1252 23 464 457 458 467 -1253 71 465 457 458 459 -1254 23 465 457 458 466 -1255 23 465 457 458 467 -1256 72 457 458 459 468 -1257 72 457 458 459 469 -1258 72 457 458 459 470 -1259 73 466 458 459 468 -1260 73 466 458 459 469 -1261 73 466 458 459 470 -1262 73 467 458 459 468 -1263 73 467 458 459 469 -1264 73 467 458 459 470 -1265 26 451 471 472 473 -1266 27 451 471 472 476 -1267 43 451 471 472 477 -1268 29 475 471 472 473 -1269 30 475 471 472 476 -1270 44 475 471 472 477 -1271 32 471 472 473 474 -1272 33 471 472 473 490 -1273 45 471 472 477 478 -1274 45 471 472 477 479 -1275 46 471 472 477 481 -1276 47 473 472 477 478 -1277 47 473 472 477 479 -1278 48 473 472 477 481 -1279 10 476 472 473 474 -1280 11 476 472 473 490 -1281 49 476 472 477 478 -1282 49 476 472 477 479 -1283 50 476 472 477 481 -1284 51 477 472 473 474 -1285 52 477 472 473 490 -1286 16 472 473 490 491 -1287 17 472 473 490 494 -1288 18 474 473 490 491 -1289 19 474 473 490 494 -1290 53 472 477 478 480 -1291 54 472 477 478 482 -1292 54 472 477 478 483 -1293 54 472 477 479 484 -1294 54 472 477 479 485 -1295 54 472 477 479 486 -1296 55 478 477 479 484 -1297 55 478 477 479 485 -1298 55 478 477 479 486 -1299 56 479 477 478 480 -1300 55 479 477 478 482 -1301 55 479 477 478 483 -1302 12 481 477 478 480 -1303 13 481 477 478 482 -1304 13 481 477 478 483 -1305 13 481 477 479 484 -1306 13 481 477 479 485 -1307 13 481 477 479 486 -1308 21 477 478 480 487 -1309 21 477 478 480 488 -1310 21 477 478 480 489 -1311 23 482 478 480 487 -1312 23 482 478 480 488 -1313 23 482 478 480 489 -1314 23 483 478 480 487 -1315 23 483 478 480 488 -1316 23 483 478 480 489 -1317 26 473 490 491 492 -1318 27 473 490 491 495 -1319 28 473 490 491 496 -1320 29 494 490 491 492 -1321 30 494 490 491 495 -1322 31 494 490 491 496 -1323 32 490 491 492 493 -1324 33 490 491 492 507 -1325 34 490 491 496 497 -1326 35 490 491 496 501 -1327 35 490 491 496 502 -1328 8 492 491 496 497 -1329 9 492 491 496 501 -1330 9 492 491 496 502 -1331 10 495 491 492 493 -1332 11 495 491 492 507 -1333 12 495 491 496 497 -1334 13 495 491 496 501 -1335 13 495 491 496 502 -1336 14 496 491 492 493 -1337 15 496 491 492 507 -1338 16 491 492 507 508 -1339 17 491 492 507 511 -1340 18 493 492 507 508 -1341 19 493 492 507 511 -1342 36 491 496 497 498 -1343 21 491 496 497 503 -1344 21 491 496 497 504 -1345 37 501 496 497 498 -1346 23 501 496 497 503 -1347 23 501 496 497 504 -1348 37 502 496 497 498 -1349 23 502 496 497 503 -1350 23 502 496 497 504 -1351 38 496 497 498 499 -1352 39 496 497 498 500 -1353 40 503 497 498 499 -1354 41 503 497 498 500 -1355 40 504 497 498 499 -1356 41 504 497 498 500 -1357 42 497 498 500 505 -1358 42 497 498 500 506 -1359 19 499 498 500 505 -1360 19 499 498 500 506 -1361 26 492 507 508 509 -1362 27 492 507 508 512 -1363 28 492 507 508 513 -1364 29 511 507 508 509 -1365 30 511 507 508 512 -1366 31 511 507 508 513 -1367 32 507 508 509 510 -1368 33 507 508 509 519 -1369 141 507 508 513 514 -1370 35 507 508 513 517 -1371 35 507 508 513 518 -1372 142 509 508 513 514 -1373 9 509 508 513 517 -1374 9 509 508 513 518 -1375 10 512 508 509 510 -1376 11 512 508 509 519 -1377 143 512 508 513 514 -1378 13 512 508 513 517 -1379 13 512 508 513 518 -1380 14 513 508 509 510 -1381 15 513 508 509 519 -1382 16 508 509 519 520 -1383 17 508 509 519 523 -1384 18 510 509 519 520 -1385 19 510 509 519 523 -1386 144 508 513 514 515 -1387 144 508 513 514 516 -1388 100 517 513 514 515 -1389 100 517 513 514 516 -1390 100 518 513 514 515 -1391 100 518 513 514 516 -1392 26 509 519 520 521 -1393 27 509 519 520 524 -1394 28 509 519 520 525 -1395 29 523 519 520 521 -1396 30 523 519 520 524 -1397 31 523 519 520 525 -1398 32 519 520 521 522 -1399 33 519 520 521 541 -1400 34 519 520 525 526 -1401 35 519 520 525 530 -1402 35 519 520 525 531 -1403 8 521 520 525 526 -1404 9 521 520 525 530 -1405 9 521 520 525 531 -1406 10 524 520 521 522 -1407 11 524 520 521 541 -1408 12 524 520 525 526 -1409 13 524 520 525 530 -1410 13 524 520 525 531 -1411 14 525 520 521 522 -1412 15 525 520 521 541 -1413 16 520 521 541 542 -1414 17 520 521 541 545 -1415 18 522 521 541 542 -1416 19 522 521 541 545 -1417 67 520 525 526 527 -1418 21 520 525 526 532 -1419 21 520 525 526 533 -1420 68 530 525 526 527 -1421 23 530 525 526 532 -1422 23 530 525 526 533 -1423 68 531 525 526 527 -1424 23 531 525 526 532 -1425 23 531 525 526 533 -1426 69 525 526 527 528 -1427 68 525 526 527 534 -1428 68 525 526 527 535 -1429 68 532 526 527 528 -1430 23 532 526 527 534 -1431 23 532 526 527 535 -1432 68 533 526 527 528 -1433 23 533 526 527 534 -1434 23 533 526 527 535 -1435 70 526 527 528 529 -1436 68 526 527 528 536 -1437 68 526 527 528 537 -1438 71 534 527 528 529 -1439 23 534 527 528 536 -1440 23 534 527 528 537 -1441 71 535 527 528 529 -1442 23 535 527 528 536 -1443 23 535 527 528 537 -1444 72 527 528 529 538 -1445 72 527 528 529 539 -1446 72 527 528 529 540 -1447 73 536 528 529 538 -1448 73 536 528 529 539 -1449 73 536 528 529 540 -1450 73 537 528 529 538 -1451 73 537 528 529 539 -1452 73 537 528 529 540 -1453 26 521 541 542 543 -1454 27 521 541 542 546 -1455 28 521 541 542 547 -1456 29 545 541 542 543 -1457 30 545 541 542 546 -1458 31 545 541 542 547 -1459 32 541 542 543 544 -1460 33 541 542 543 556 -1461 34 541 542 547 548 -1462 35 541 542 547 552 -1463 35 541 542 547 553 -1464 8 543 542 547 548 -1465 9 543 542 547 552 -1466 9 543 542 547 553 -1467 10 546 542 543 544 -1468 11 546 542 543 556 -1469 12 546 542 547 548 -1470 13 546 542 547 552 -1471 13 546 542 547 553 -1472 14 547 542 543 544 -1473 15 547 542 543 556 -1474 85 542 543 556 557 -1475 17 542 543 556 560 -1476 86 544 543 556 557 -1477 19 544 543 556 560 -1478 97 542 547 548 549 -1479 21 542 547 548 554 -1480 21 542 547 548 555 -1481 98 552 547 548 549 -1482 23 552 547 548 554 -1483 23 552 547 548 555 -1484 98 553 547 548 549 -1485 23 553 547 548 554 -1486 23 553 547 548 555 -1487 99 547 548 549 550 -1488 99 547 548 549 551 -1489 100 554 548 549 550 -1490 100 554 548 549 551 -1491 100 555 548 549 550 -1492 100 555 548 549 551 -1493 87 543 556 557 558 -1494 88 543 556 557 561 -1495 88 543 556 557 562 -1496 89 560 556 557 558 -1497 90 560 556 557 561 -1498 90 560 556 557 562 -1499 91 556 557 558 559 -1500 92 556 557 558 563 -1501 93 561 557 558 559 -1502 94 561 557 558 563 -1503 93 562 557 558 559 -1504 94 562 557 558 563 -1505 95 557 558 563 564 -1506 96 557 558 563 567 -1507 18 559 558 563 564 -1508 19 559 558 563 567 -1509 26 558 563 564 565 -1510 27 558 563 564 568 -1511 43 558 563 564 569 -1512 29 567 563 564 565 -1513 30 567 563 564 568 -1514 44 567 563 564 569 -1515 32 563 564 565 566 -1516 101 563 564 565 582 -1517 45 563 564 569 570 -1518 45 563 564 569 571 -1519 46 563 564 569 573 -1520 47 565 564 569 570 -1521 47 565 564 569 571 -1522 48 565 564 569 573 -1523 10 568 564 565 566 -1524 102 568 564 565 582 -1525 49 568 564 569 570 -1526 49 568 564 569 571 -1527 50 568 564 569 573 -1528 51 569 564 565 566 -1529 150 569 564 565 582 -1530 104 564 565 582 583 -1531 105 564 565 582 589 -1532 106 566 565 582 583 -1533 107 566 565 582 589 -1534 53 564 569 570 572 -1535 54 564 569 570 574 -1536 54 564 569 570 575 -1537 54 564 569 571 576 -1538 54 564 569 571 577 -1539 54 564 569 571 578 -1540 55 570 569 571 576 -1541 55 570 569 571 577 -1542 55 570 569 571 578 -1543 56 571 569 570 572 -1544 55 571 569 570 574 -1545 55 571 569 570 575 -1546 12 573 569 570 572 -1547 13 573 569 570 574 -1548 13 573 569 570 575 -1549 13 573 569 571 576 -1550 13 573 569 571 577 -1551 13 573 569 571 578 -1552 21 569 570 572 579 -1553 21 569 570 572 580 -1554 21 569 570 572 581 -1555 23 574 570 572 579 -1556 23 574 570 572 580 -1557 23 574 570 572 581 -1558 23 575 570 572 579 -1559 23 575 570 572 580 -1560 23 575 570 572 581 -1561 108 565 582 583 584 -1562 109 565 582 583 586 -1563 110 565 582 583 587 -1564 111 565 582 589 588 -1565 112 565 582 589 594 -1566 112 565 582 589 595 -1567 113 583 582 589 588 -1568 114 583 582 589 594 -1569 114 583 582 589 595 -1570 115 589 582 583 584 -1571 116 589 582 583 586 -1572 117 589 582 583 587 -1573 118 582 583 584 585 -1574 151 582 583 584 596 -1575 120 582 583 587 588 -1576 121 582 583 587 590 -1577 121 582 583 587 591 -1578 122 584 583 587 588 -1579 123 584 583 587 590 -1580 123 584 583 587 591 -1581 10 586 583 584 585 -1582 102 586 583 584 596 -1583 124 586 583 587 588 -1584 125 586 583 587 590 -1585 125 586 583 587 591 -1586 126 587 583 584 585 -1587 152 587 583 584 596 -1588 104 583 584 596 597 -1589 105 583 584 596 603 -1590 106 585 584 596 597 -1591 107 585 584 596 603 -1592 128 583 587 588 589 -1593 129 583 587 588 592 -1594 129 583 587 588 593 -1595 130 590 587 588 589 -1596 131 590 587 588 592 -1597 131 590 587 588 593 -1598 130 591 587 588 589 -1599 131 591 587 588 592 -1600 131 591 587 588 593 -1601 132 587 588 589 582 -1602 133 587 588 589 594 -1603 133 587 588 589 595 -1604 134 592 588 589 582 -1605 135 592 588 589 594 -1606 135 592 588 589 595 -1607 134 593 588 589 582 -1608 135 593 588 589 594 -1609 135 593 588 589 595 -1610 108 584 596 597 598 -1611 109 584 596 597 600 -1612 110 584 596 597 601 -1613 111 584 596 603 602 -1614 112 584 596 603 608 -1615 112 584 596 603 609 -1616 113 597 596 603 602 -1617 114 597 596 603 608 -1618 114 597 596 603 609 -1619 115 603 596 597 598 -1620 116 603 596 597 600 -1621 117 603 596 597 601 -1622 118 596 597 598 599 -1623 119 596 597 598 610 -1624 120 596 597 601 602 -1625 121 596 597 601 604 -1626 121 596 597 601 605 -1627 122 598 597 601 602 -1628 123 598 597 601 604 -1629 123 598 597 601 605 -1630 10 600 597 598 599 -1631 11 600 597 598 610 -1632 124 600 597 601 602 -1633 125 600 597 601 604 -1634 125 600 597 601 605 -1635 126 601 597 598 599 -1636 127 601 597 598 610 -1637 16 597 598 610 611 -1638 17 597 598 610 614 -1639 18 599 598 610 611 -1640 19 599 598 610 614 -1641 128 597 601 602 603 -1642 129 597 601 602 606 -1643 129 597 601 602 607 -1644 130 604 601 602 603 -1645 131 604 601 602 606 -1646 131 604 601 602 607 -1647 130 605 601 602 603 -1648 131 605 601 602 606 -1649 131 605 601 602 607 -1650 132 601 602 603 596 -1651 133 601 602 603 608 -1652 133 601 602 603 609 -1653 134 606 602 603 596 -1654 135 606 602 603 608 -1655 135 606 602 603 609 -1656 134 607 602 603 596 -1657 135 607 602 603 608 -1658 135 607 602 603 609 -1659 26 598 610 611 612 -1660 27 598 610 611 615 -1661 28 598 610 611 616 -1662 29 614 610 611 612 -1663 30 614 610 611 615 -1664 31 614 610 611 616 -1665 32 610 611 612 613 -1666 33 610 611 612 622 -1667 141 610 611 616 617 -1668 35 610 611 616 620 -1669 35 610 611 616 621 -1670 142 612 611 616 617 -1671 9 612 611 616 620 -1672 9 612 611 616 621 -1673 10 615 611 612 613 -1674 11 615 611 612 622 -1675 143 615 611 616 617 -1676 13 615 611 616 620 -1677 13 615 611 616 621 -1678 14 616 611 612 613 -1679 15 616 611 612 622 -1680 16 611 612 622 623 -1681 17 611 612 622 626 -1682 18 613 612 622 623 -1683 19 613 612 622 626 -1684 144 611 616 617 618 -1685 144 611 616 617 619 -1686 100 620 616 617 618 -1687 100 620 616 617 619 -1688 100 621 616 617 618 -1689 100 621 616 617 619 -1690 26 612 622 623 624 -1691 27 612 622 623 627 -1692 28 612 622 623 628 -1693 29 626 622 623 624 -1694 30 626 622 623 627 -1695 31 626 622 623 628 -1696 32 622 623 624 625 -1697 33 622 623 624 639 -1698 34 622 623 628 629 -1699 35 622 623 628 633 -1700 35 622 623 628 634 -1701 8 624 623 628 629 -1702 9 624 623 628 633 -1703 9 624 623 628 634 -1704 10 627 623 624 625 -1705 11 627 623 624 639 -1706 12 627 623 628 629 -1707 13 627 623 628 633 -1708 13 627 623 628 634 -1709 14 628 623 624 625 -1710 15 628 623 624 639 -1711 16 623 624 639 640 -1712 17 623 624 639 643 -1713 18 625 624 639 640 -1714 19 625 624 639 643 -1715 36 623 628 629 630 -1716 21 623 628 629 635 -1717 21 623 628 629 636 -1718 37 633 628 629 630 -1719 23 633 628 629 635 -1720 23 633 628 629 636 -1721 37 634 628 629 630 -1722 23 634 628 629 635 -1723 23 634 628 629 636 -1724 38 628 629 630 631 -1725 39 628 629 630 632 -1726 40 635 629 630 631 -1727 41 635 629 630 632 -1728 40 636 629 630 631 -1729 41 636 629 630 632 -1730 42 629 630 632 637 -1731 42 629 630 632 638 -1732 19 631 630 632 637 -1733 19 631 630 632 638 -1734 26 624 639 640 641 -1735 27 624 639 640 644 -1736 28 624 639 640 645 -1737 29 643 639 640 641 -1738 30 643 639 640 644 -1739 31 643 639 640 645 -1740 32 639 640 641 642 -1741 33 639 640 641 656 -1742 34 639 640 645 646 -1743 35 639 640 645 650 -1744 35 639 640 645 651 -1745 8 641 640 645 646 -1746 9 641 640 645 650 -1747 9 641 640 645 651 -1748 10 644 640 641 642 -1749 11 644 640 641 656 -1750 12 644 640 645 646 -1751 13 644 640 645 650 -1752 13 644 640 645 651 -1753 14 645 640 641 642 -1754 15 645 640 641 656 -1755 16 640 641 656 657 -1756 17 640 641 656 660 -1757 18 642 641 656 657 -1758 19 642 641 656 660 -1759 36 640 645 646 647 -1760 21 640 645 646 652 -1761 21 640 645 646 653 -1762 37 650 645 646 647 -1763 23 650 645 646 652 -1764 23 650 645 646 653 -1765 37 651 645 646 647 -1766 23 651 645 646 652 -1767 23 651 645 646 653 -1768 38 645 646 647 648 -1769 39 645 646 647 649 -1770 40 652 646 647 648 -1771 41 652 646 647 649 -1772 40 653 646 647 648 -1773 41 653 646 647 649 -1774 42 646 647 649 654 -1775 42 646 647 649 655 -1776 19 648 647 649 654 -1777 19 648 647 649 655 -1778 26 641 656 657 658 -1779 27 641 656 657 661 -1780 28 641 656 657 662 -1781 29 660 656 657 658 -1782 30 660 656 657 661 -1783 31 660 656 657 662 -1784 32 656 657 658 659 -1785 33 656 657 658 680 -1786 34 656 657 662 663 -1787 35 656 657 662 669 -1788 35 656 657 662 670 -1789 8 658 657 662 663 -1790 9 658 657 662 669 -1791 9 658 657 662 670 -1792 10 661 657 658 659 -1793 11 661 657 658 680 -1794 12 661 657 662 663 -1795 13 661 657 662 669 -1796 13 661 657 662 670 -1797 14 662 657 658 659 -1798 15 662 657 658 680 -1799 16 657 658 680 681 -1800 17 657 658 680 684 -1801 18 659 658 680 681 -1802 19 659 658 680 684 -1803 67 657 662 663 664 -1804 21 657 662 663 671 -1805 21 657 662 663 672 -1806 68 669 662 663 664 -1807 23 669 662 663 671 -1808 23 669 662 663 672 -1809 68 670 662 663 664 -1810 23 670 662 663 671 -1811 23 670 662 663 672 -1812 153 662 663 664 665 -1813 68 662 663 664 673 -1814 68 662 663 664 674 -1815 154 671 663 664 665 -1816 23 671 663 664 673 -1817 23 671 663 664 674 -1818 154 672 663 664 665 -1819 23 672 663 664 673 -1820 23 672 663 664 674 -1821 155 663 664 665 666 -1822 156 663 664 665 675 -1823 157 673 664 665 666 -1824 158 673 664 665 675 -1825 157 674 664 665 666 -1826 158 674 664 665 675 -1827 159 664 665 666 667 -1828 159 664 665 666 668 -1829 160 675 665 666 667 -1830 160 675 665 666 668 -1831 160 665 666 667 676 -1832 160 665 666 667 677 -1833 160 665 666 668 678 -1834 160 665 666 668 679 -1835 160 667 666 668 678 -1836 160 667 666 668 679 -1837 160 668 666 667 676 -1838 160 668 666 667 677 -1839 26 658 680 681 682 -1840 27 658 680 681 685 -1841 28 658 680 681 686 -1842 29 684 680 681 682 -1843 30 684 680 681 685 -1844 31 684 680 681 686 -1845 32 680 681 682 683 -1846 33 680 681 682 699 -1847 81 680 681 686 687 -1848 35 680 681 686 690 -1849 35 680 681 686 691 -1850 82 682 681 686 687 -1851 9 682 681 686 690 -1852 9 682 681 686 691 -1853 10 685 681 682 683 -1854 11 685 681 682 699 -1855 83 685 681 686 687 -1856 13 685 681 686 690 -1857 13 685 681 686 691 -1858 14 686 681 682 683 -1859 15 686 681 682 699 -1860 16 681 682 699 700 -1861 17 681 682 699 703 -1862 18 683 682 699 700 -1863 19 683 682 699 703 -1864 84 681 686 687 688 -1865 84 681 686 687 689 -1866 83 681 686 687 692 -1867 55 690 686 687 688 -1868 55 690 686 687 689 -1869 13 690 686 687 692 -1870 55 691 686 687 688 -1871 55 691 686 687 689 -1872 13 691 686 687 692 -1873 55 686 687 688 693 -1874 55 686 687 688 694 -1875 55 686 687 688 695 -1876 55 686 687 689 696 -1877 55 686 687 689 697 -1878 55 686 687 689 698 -1879 55 688 687 689 696 -1880 55 688 687 689 697 -1881 55 688 687 689 698 -1882 55 689 687 688 693 -1883 55 689 687 688 694 -1884 55 689 687 688 695 -1885 13 692 687 688 693 -1886 13 692 687 688 694 -1887 13 692 687 688 695 -1888 13 692 687 689 696 -1889 13 692 687 689 697 -1890 13 692 687 689 698 -1891 26 682 699 700 701 -1892 27 682 699 700 704 -1893 43 682 699 700 705 -1894 29 703 699 700 701 -1895 30 703 699 700 704 -1896 44 703 699 700 705 -1897 32 699 700 701 702 -1898 33 699 700 701 718 -1899 45 699 700 705 706 -1900 45 699 700 705 707 -1901 46 699 700 705 709 -1902 47 701 700 705 706 -1903 47 701 700 705 707 -1904 48 701 700 705 709 -1905 10 704 700 701 702 -1906 11 704 700 701 718 -1907 49 704 700 705 706 -1908 49 704 700 705 707 -1909 50 704 700 705 709 -1910 51 705 700 701 702 -1911 52 705 700 701 718 -1912 16 700 701 718 719 -1913 17 700 701 718 722 -1914 18 702 701 718 719 -1915 19 702 701 718 722 -1916 53 700 705 706 708 -1917 54 700 705 706 710 -1918 54 700 705 706 711 -1919 54 700 705 707 712 -1920 54 700 705 707 713 -1921 54 700 705 707 714 -1922 55 706 705 707 712 -1923 55 706 705 707 713 -1924 55 706 705 707 714 -1925 56 707 705 706 708 -1926 55 707 705 706 710 -1927 55 707 705 706 711 -1928 12 709 705 706 708 -1929 13 709 705 706 710 -1930 13 709 705 706 711 -1931 13 709 705 707 712 -1932 13 709 705 707 713 -1933 13 709 705 707 714 -1934 21 705 706 708 715 -1935 21 705 706 708 716 -1936 21 705 706 708 717 -1937 23 710 706 708 715 -1938 23 710 706 708 716 -1939 23 710 706 708 717 -1940 23 711 706 708 715 -1941 23 711 706 708 716 -1942 23 711 706 708 717 -1943 26 701 718 719 720 -1944 27 701 718 719 723 -1945 28 701 718 719 724 -1946 29 722 718 719 720 -1947 30 722 718 719 723 -1948 31 722 718 719 724 -1949 32 718 719 720 721 -1950 33 718 719 720 738 -1951 57 718 719 724 725 -1952 35 718 719 724 731 -1953 35 718 719 724 732 -1954 58 720 719 724 725 -1955 9 720 719 724 731 -1956 9 720 719 724 732 -1957 10 723 719 720 721 -1958 11 723 719 720 738 -1959 59 723 719 724 725 -1960 13 723 719 724 731 -1961 13 723 719 724 732 -1962 14 724 719 720 721 -1963 15 724 719 720 738 -1964 16 719 720 738 739 -1965 17 719 720 738 742 -1966 18 721 720 738 739 -1967 19 721 720 738 742 -1968 60 719 724 725 726 -1969 60 719 724 725 727 -1970 61 731 724 725 726 -1971 61 731 724 725 727 -1972 61 732 724 725 726 -1973 61 732 724 725 727 -1974 62 724 725 726 728 -1975 63 724 725 726 733 -1976 62 724 725 727 729 -1977 63 724 725 727 734 -1978 64 726 725 727 729 -1979 65 726 725 727 734 -1980 64 727 725 726 728 -1981 65 727 725 726 733 -1982 64 725 726 728 730 -1983 65 725 726 728 735 -1984 65 733 726 728 730 -1985 66 733 726 728 735 -1986 64 725 727 729 730 -1987 65 725 727 729 736 -1988 65 734 727 729 730 -1989 66 734 727 729 736 -1990 64 726 728 730 729 -1991 65 726 728 730 737 -1992 65 735 728 730 729 -1993 66 735 728 730 737 -1994 64 727 729 730 728 -1995 65 727 729 730 737 -1996 65 736 729 730 728 -1997 66 736 729 730 737 -1998 26 720 738 739 740 -1999 27 720 738 739 743 -2000 28 720 738 739 744 -2001 29 742 738 739 740 -2002 30 742 738 739 743 -2003 31 742 738 739 744 -2004 32 738 739 740 741 -2005 33 738 739 740 748 -2006 35 738 739 744 745 -2007 35 738 739 744 746 -2008 35 738 739 744 747 -2009 9 740 739 744 745 -2010 9 740 739 744 746 -2011 9 740 739 744 747 -2012 10 743 739 740 741 -2013 11 743 739 740 748 -2014 13 743 739 744 745 -2015 13 743 739 744 746 -2016 13 743 739 744 747 -2017 14 744 739 740 741 -2018 15 744 739 740 748 -2019 85 739 740 748 749 -2020 17 739 740 748 752 -2021 86 741 740 748 749 -2022 19 741 740 748 752 -2023 87 740 748 749 750 -2024 88 740 748 749 753 -2025 88 740 748 749 754 -2026 89 752 748 749 750 -2027 90 752 748 749 753 -2028 90 752 748 749 754 -2029 91 748 749 750 751 -2030 92 748 749 750 755 -2031 93 753 749 750 751 -2032 94 753 749 750 755 -2033 93 754 749 750 751 -2034 94 754 749 750 755 -2035 95 749 750 755 756 -2036 96 749 750 755 759 -2037 18 751 750 755 756 -2038 19 751 750 755 759 -2039 26 750 755 756 757 -2040 27 750 755 756 760 -2041 28 750 755 756 761 -2042 29 759 755 756 757 -2043 30 759 755 756 760 -2044 31 759 755 756 761 -2045 32 755 756 757 758 -2046 33 755 756 757 777 -2047 34 755 756 761 762 -2048 35 755 756 761 766 -2049 35 755 756 761 767 -2050 8 757 756 761 762 -2051 9 757 756 761 766 -2052 9 757 756 761 767 -2053 10 760 756 757 758 -2054 11 760 756 757 777 -2055 12 760 756 761 762 -2056 13 760 756 761 766 -2057 13 760 756 761 767 -2058 14 761 756 757 758 -2059 15 761 756 757 777 -2060 16 756 757 777 778 -2061 17 756 757 777 781 -2062 18 758 757 777 778 -2063 19 758 757 777 781 -2064 67 756 761 762 763 -2065 21 756 761 762 768 -2066 21 756 761 762 769 -2067 68 766 761 762 763 -2068 23 766 761 762 768 -2069 23 766 761 762 769 -2070 68 767 761 762 763 -2071 23 767 761 762 768 -2072 23 767 761 762 769 -2073 69 761 762 763 764 -2074 68 761 762 763 770 -2075 68 761 762 763 771 -2076 68 768 762 763 764 -2077 23 768 762 763 770 -2078 23 768 762 763 771 -2079 68 769 762 763 764 -2080 23 769 762 763 770 -2081 23 769 762 763 771 -2082 70 762 763 764 765 -2083 68 762 763 764 772 -2084 68 762 763 764 773 -2085 71 770 763 764 765 -2086 23 770 763 764 772 -2087 23 770 763 764 773 -2088 71 771 763 764 765 -2089 23 771 763 764 772 -2090 23 771 763 764 773 -2091 72 763 764 765 774 -2092 72 763 764 765 775 -2093 72 763 764 765 776 -2094 73 772 764 765 774 -2095 73 772 764 765 775 -2096 73 772 764 765 776 -2097 73 773 764 765 774 -2098 73 773 764 765 775 -2099 73 773 764 765 776 -2100 26 757 777 778 779 -2101 27 757 777 778 782 -2102 28 757 777 778 783 -2103 29 781 777 778 779 -2104 30 781 777 778 782 -2105 31 781 777 778 783 -2106 32 777 778 779 780 -2107 33 777 778 779 794 -2108 34 777 778 783 784 -2109 35 777 778 783 788 -2110 35 777 778 783 789 -2111 8 779 778 783 784 -2112 9 779 778 783 788 -2113 9 779 778 783 789 -2114 10 782 778 779 780 -2115 11 782 778 779 794 -2116 12 782 778 783 784 -2117 13 782 778 783 788 -2118 13 782 778 783 789 -2119 14 783 778 779 780 -2120 15 783 778 779 794 -2121 16 778 779 794 795 -2122 17 778 779 794 798 -2123 18 780 779 794 795 -2124 19 780 779 794 798 -2125 36 778 783 784 785 -2126 21 778 783 784 790 -2127 21 778 783 784 791 -2128 37 788 783 784 785 -2129 23 788 783 784 790 -2130 23 788 783 784 791 -2131 37 789 783 784 785 -2132 23 789 783 784 790 -2133 23 789 783 784 791 -2134 38 783 784 785 786 -2135 39 783 784 785 787 -2136 40 790 784 785 786 -2137 41 790 784 785 787 -2138 40 791 784 785 786 -2139 41 791 784 785 787 -2140 42 784 785 787 792 -2141 42 784 785 787 793 -2142 19 786 785 787 792 -2143 19 786 785 787 793 -2144 26 779 794 795 796 -2145 27 779 794 795 799 -2146 28 779 794 795 800 -2147 29 798 794 795 796 -2148 30 798 794 795 799 -2149 31 798 794 795 800 -2150 32 794 795 796 797 -2151 33 794 795 796 813 -2152 81 794 795 800 801 -2153 35 794 795 800 804 -2154 35 794 795 800 805 -2155 82 796 795 800 801 -2156 9 796 795 800 804 -2157 9 796 795 800 805 -2158 10 799 795 796 797 -2159 11 799 795 796 813 -2160 83 799 795 800 801 -2161 13 799 795 800 804 -2162 13 799 795 800 805 -2163 14 800 795 796 797 -2164 15 800 795 796 813 -2165 16 795 796 813 814 -2166 17 795 796 813 817 -2167 18 797 796 813 814 -2168 19 797 796 813 817 -2169 84 795 800 801 802 -2170 84 795 800 801 803 -2171 83 795 800 801 806 -2172 55 804 800 801 802 -2173 55 804 800 801 803 -2174 13 804 800 801 806 -2175 55 805 800 801 802 -2176 55 805 800 801 803 -2177 13 805 800 801 806 -2178 55 800 801 802 807 -2179 55 800 801 802 808 -2180 55 800 801 802 809 -2181 55 800 801 803 810 -2182 55 800 801 803 811 -2183 55 800 801 803 812 -2184 55 802 801 803 810 -2185 55 802 801 803 811 -2186 55 802 801 803 812 -2187 55 803 801 802 807 -2188 55 803 801 802 808 -2189 55 803 801 802 809 -2190 13 806 801 802 807 -2191 13 806 801 802 808 -2192 13 806 801 802 809 -2193 13 806 801 803 810 -2194 13 806 801 803 811 -2195 13 806 801 803 812 -2196 26 796 813 814 815 -2197 27 796 813 814 818 -2198 28 796 813 814 819 -2199 29 817 813 814 815 -2200 30 817 813 814 818 -2201 31 817 813 814 819 -2202 32 813 814 815 816 -2203 33 813 814 815 828 -2204 34 813 814 819 820 -2205 35 813 814 819 824 -2206 35 813 814 819 825 -2207 8 815 814 819 820 -2208 9 815 814 819 824 -2209 9 815 814 819 825 -2210 10 818 814 815 816 -2211 11 818 814 815 828 -2212 12 818 814 819 820 -2213 13 818 814 819 824 -2214 13 818 814 819 825 -2215 14 819 814 815 816 -2216 15 819 814 815 828 -2217 16 814 815 828 829 -2218 17 814 815 828 832 -2219 18 816 815 828 829 -2220 19 816 815 828 832 -2221 97 814 819 820 821 -2222 21 814 819 820 826 -2223 21 814 819 820 827 -2224 98 824 819 820 821 -2225 23 824 819 820 826 -2226 23 824 819 820 827 -2227 98 825 819 820 821 -2228 23 825 819 820 826 -2229 23 825 819 820 827 -2230 99 819 820 821 822 -2231 99 819 820 821 823 -2232 100 826 820 821 822 -2233 100 826 820 821 823 -2234 100 827 820 821 822 -2235 100 827 820 821 823 -2236 26 815 828 829 830 -2237 27 815 828 829 833 -2238 28 815 828 829 834 -2239 29 832 828 829 830 -2240 30 832 828 829 833 -2241 31 832 828 829 834 -2242 32 828 829 830 831 -2243 33 828 829 830 840 -2244 141 828 829 834 835 -2245 35 828 829 834 838 -2246 35 828 829 834 839 -2247 142 830 829 834 835 -2248 9 830 829 834 838 -2249 9 830 829 834 839 -2250 10 833 829 830 831 -2251 11 833 829 830 840 -2252 143 833 829 834 835 -2253 13 833 829 834 838 -2254 13 833 829 834 839 -2255 14 834 829 830 831 -2256 15 834 829 830 840 -2257 85 829 830 840 841 -2258 17 829 830 840 844 -2259 86 831 830 840 841 -2260 19 831 830 840 844 -2261 144 829 834 835 836 -2262 144 829 834 835 837 -2263 100 838 834 835 836 -2264 100 838 834 835 837 -2265 100 839 834 835 836 -2266 100 839 834 835 837 -2267 87 830 840 841 842 -2268 88 830 840 841 845 -2269 88 830 840 841 846 -2270 89 844 840 841 842 -2271 90 844 840 841 845 -2272 90 844 840 841 846 -2273 91 840 841 842 843 -2274 92 840 841 842 847 -2275 93 845 841 842 843 -2276 94 845 841 842 847 -2277 93 846 841 842 843 -2278 94 846 841 842 847 -2279 95 841 842 847 848 -2280 96 841 842 847 851 -2281 18 843 842 847 848 -2282 19 843 842 847 851 -2283 26 842 847 848 849 -2284 27 842 847 848 852 -2285 28 842 847 848 853 -2286 29 851 847 848 849 -2287 30 851 847 848 852 -2288 31 851 847 848 853 -2289 32 847 848 849 850 -2290 33 847 848 849 871 -2291 34 847 848 853 854 -2292 35 847 848 853 860 -2293 35 847 848 853 861 -2294 8 849 848 853 854 -2295 9 849 848 853 860 -2296 9 849 848 853 861 -2297 10 852 848 849 850 -2298 11 852 848 849 871 -2299 12 852 848 853 854 -2300 13 852 848 853 860 -2301 13 852 848 853 861 -2302 14 853 848 849 850 -2303 15 853 848 849 871 -2304 16 848 849 871 872 -2305 17 848 849 871 875 -2306 18 850 849 871 872 -2307 19 850 849 871 875 -2308 67 848 853 854 855 -2309 21 848 853 854 862 -2310 21 848 853 854 863 -2311 68 860 853 854 855 -2312 23 860 853 854 862 -2313 23 860 853 854 863 -2314 68 861 853 854 855 -2315 23 861 853 854 862 -2316 23 861 853 854 863 -2317 153 853 854 855 856 -2318 68 853 854 855 864 -2319 68 853 854 855 865 -2320 154 862 854 855 856 -2321 23 862 854 855 864 -2322 23 862 854 855 865 -2323 154 863 854 855 856 -2324 23 863 854 855 864 -2325 23 863 854 855 865 -2326 155 854 855 856 857 -2327 156 854 855 856 866 -2328 157 864 855 856 857 -2329 158 864 855 856 866 -2330 157 865 855 856 857 -2331 158 865 855 856 866 -2332 159 855 856 857 858 -2333 159 855 856 857 859 -2334 160 866 856 857 858 -2335 160 866 856 857 859 -2336 160 856 857 858 867 -2337 160 856 857 858 868 -2338 160 856 857 859 869 -2339 160 856 857 859 870 -2340 160 858 857 859 869 -2341 160 858 857 859 870 -2342 160 859 857 858 867 -2343 160 859 857 858 868 -2344 26 849 871 872 873 -2345 27 849 871 872 876 -2346 43 849 871 872 877 -2347 29 875 871 872 873 -2348 30 875 871 872 876 -2349 44 875 871 872 877 -2350 32 871 872 873 874 -2351 33 871 872 873 885 -2352 74 871 872 877 878 -2353 45 871 872 877 879 -2354 46 871 872 877 880 -2355 75 873 872 877 878 -2356 47 873 872 877 879 -2357 48 873 872 877 880 -2358 10 876 872 873 874 -2359 11 876 872 873 885 -2360 76 876 872 877 878 -2361 49 876 872 877 879 -2362 50 876 872 877 880 -2363 51 877 872 873 874 -2364 52 877 872 873 885 -2365 16 872 873 885 886 -2366 17 872 873 885 889 -2367 18 874 873 885 886 -2368 19 874 873 885 889 -2369 77 872 877 878 881 -2370 54 872 877 879 882 -2371 54 872 877 879 883 -2372 54 872 877 879 884 -2373 78 878 877 879 882 -2374 78 878 877 879 883 -2375 78 878 877 879 884 -2376 79 879 877 878 881 -2377 80 880 877 878 881 -2378 13 880 877 879 882 -2379 13 880 877 879 883 -2380 13 880 877 879 884 -2381 26 873 885 886 887 -2382 27 873 885 886 890 -2383 28 873 885 886 891 -2384 29 889 885 886 887 -2385 30 889 885 886 890 -2386 31 889 885 886 891 -2387 32 885 886 887 888 -2388 33 885 886 887 904 -2389 81 885 886 891 892 -2390 35 885 886 891 895 -2391 35 885 886 891 896 -2392 82 887 886 891 892 -2393 9 887 886 891 895 -2394 9 887 886 891 896 -2395 10 890 886 887 888 -2396 11 890 886 887 904 -2397 83 890 886 891 892 -2398 13 890 886 891 895 -2399 13 890 886 891 896 -2400 14 891 886 887 888 -2401 15 891 886 887 904 -2402 16 886 887 904 905 -2403 17 886 887 904 908 -2404 18 888 887 904 905 -2405 19 888 887 904 908 -2406 84 886 891 892 893 -2407 84 886 891 892 894 -2408 83 886 891 892 897 -2409 55 895 891 892 893 -2410 55 895 891 892 894 -2411 13 895 891 892 897 -2412 55 896 891 892 893 -2413 55 896 891 892 894 -2414 13 896 891 892 897 -2415 55 891 892 893 898 -2416 55 891 892 893 899 -2417 55 891 892 893 900 -2418 55 891 892 894 901 -2419 55 891 892 894 902 -2420 55 891 892 894 903 -2421 55 893 892 894 901 -2422 55 893 892 894 902 -2423 55 893 892 894 903 -2424 55 894 892 893 898 -2425 55 894 892 893 899 -2426 55 894 892 893 900 -2427 13 897 892 893 898 -2428 13 897 892 893 899 -2429 13 897 892 893 900 -2430 13 897 892 894 901 -2431 13 897 892 894 902 -2432 13 897 892 894 903 -2433 26 887 904 905 906 -2434 27 887 904 905 909 -2435 28 887 904 905 910 -2436 29 908 904 905 906 -2437 30 908 904 905 909 -2438 31 908 904 905 910 -2439 32 904 905 906 907 -2440 33 904 905 906 915 -2441 136 904 905 910 911 -2442 35 904 905 910 912 -2443 35 904 905 910 913 -2444 137 906 905 910 911 -2445 9 906 905 910 912 -2446 9 906 905 910 913 -2447 10 909 905 906 907 -2448 11 909 905 906 915 -2449 138 909 905 910 911 -2450 13 909 905 910 912 -2451 13 909 905 910 913 -2452 14 910 905 906 907 -2453 15 910 905 906 915 -2454 16 905 906 915 916 -2455 17 905 906 915 919 -2456 18 907 906 915 916 -2457 19 907 906 915 919 -2458 139 905 910 911 914 -2459 140 912 910 911 914 -2460 140 913 910 911 914 -2461 26 906 915 916 917 -2462 27 906 915 916 920 -2463 28 906 915 916 921 -2464 29 919 915 916 917 -2465 30 919 915 916 920 -2466 31 919 915 916 921 -2467 32 915 916 917 918 -2468 33 915 916 917 927 -2469 141 915 916 921 922 -2470 35 915 916 921 925 -2471 35 915 916 921 926 -2472 142 917 916 921 922 -2473 9 917 916 921 925 -2474 9 917 916 921 926 -2475 10 920 916 917 918 -2476 11 920 916 917 927 -2477 143 920 916 921 922 -2478 13 920 916 921 925 -2479 13 920 916 921 926 -2480 14 921 916 917 918 -2481 15 921 916 917 927 -2482 16 916 917 927 928 -2483 17 916 917 927 931 -2484 18 918 917 927 928 -2485 19 918 917 927 931 -2486 144 916 921 922 923 -2487 144 916 921 922 924 -2488 100 925 921 922 923 -2489 100 925 921 922 924 -2490 100 926 921 922 923 -2491 100 926 921 922 924 -2492 26 917 927 928 929 -2493 27 917 927 928 932 -2494 28 917 927 928 933 -2495 29 931 927 928 929 -2496 30 931 927 928 932 -2497 31 931 927 928 933 -2498 32 927 928 929 930 -2499 33 927 928 929 948 -2500 57 927 928 933 934 -2501 35 927 928 933 941 -2502 35 927 928 933 942 -2503 58 929 928 933 934 -2504 9 929 928 933 941 -2505 9 929 928 933 942 -2506 10 932 928 929 930 -2507 11 932 928 929 948 -2508 59 932 928 933 934 -2509 13 932 928 933 941 -2510 13 932 928 933 942 -2511 14 933 928 929 930 -2512 15 933 928 929 948 -2513 16 928 929 948 949 -2514 17 928 929 948 952 -2515 18 930 929 948 949 -2516 19 930 929 948 952 -2517 60 928 933 934 935 -2518 60 928 933 934 936 -2519 61 941 933 934 935 -2520 61 941 933 934 936 -2521 61 942 933 934 935 -2522 61 942 933 934 936 -2523 62 933 934 935 937 -2524 63 933 934 935 943 -2525 62 933 934 936 938 -2526 63 933 934 936 944 -2527 64 935 934 936 938 -2528 65 935 934 936 944 -2529 64 936 934 935 937 -2530 65 936 934 935 943 -2531 64 934 935 937 939 -2532 65 934 935 937 945 -2533 65 943 935 937 939 -2534 66 943 935 937 945 -2535 64 934 936 938 939 -2536 65 934 936 938 946 -2537 65 944 936 938 939 -2538 66 944 936 938 946 -2539 64 935 937 939 938 -2540 161 935 937 939 940 -2541 65 945 937 939 938 -2542 162 945 937 939 940 -2543 64 936 938 939 937 -2544 161 936 938 939 940 -2545 65 946 938 939 937 -2546 162 946 938 939 940 -2547 163 937 939 940 947 -2548 163 938 939 940 947 -2549 26 929 948 949 950 -2550 27 929 948 949 953 -2551 28 929 948 949 954 -2552 29 952 948 949 950 -2553 30 952 948 949 953 -2554 31 952 948 949 954 -2555 32 948 949 950 951 -2556 33 948 949 950 962 -2557 145 948 949 954 955 -2558 35 948 949 954 958 -2559 35 948 949 954 959 -2560 146 950 949 954 955 -2561 9 950 949 954 958 -2562 9 950 949 954 959 -2563 10 953 949 950 951 -2564 11 953 949 950 962 -2565 147 953 949 954 955 -2566 13 953 949 954 958 -2567 13 953 949 954 959 -2568 14 954 949 950 951 -2569 15 954 949 950 962 -2570 16 949 950 962 963 -2571 17 949 950 962 966 -2572 18 951 950 962 963 -2573 19 951 950 962 966 -2574 148 949 954 955 956 -2575 149 949 954 955 957 -2576 40 958 954 955 956 -2577 41 958 954 955 957 -2578 40 959 954 955 956 -2579 41 959 954 955 957 -2580 42 954 955 957 960 -2581 42 954 955 957 961 -2582 19 956 955 957 960 -2583 19 956 955 957 961 -2584 26 950 962 963 964 -2585 27 950 962 963 967 -2586 43 950 962 963 968 -2587 29 966 962 963 964 -2588 30 966 962 963 967 -2589 44 966 962 963 968 -2590 32 962 963 964 965 -2591 33 962 963 964 981 -2592 45 962 963 968 969 -2593 45 962 963 968 970 -2594 46 962 963 968 972 -2595 47 964 963 968 969 -2596 47 964 963 968 970 -2597 48 964 963 968 972 -2598 10 967 963 964 965 -2599 11 967 963 964 981 -2600 49 967 963 968 969 -2601 49 967 963 968 970 -2602 50 967 963 968 972 -2603 51 968 963 964 965 -2604 52 968 963 964 981 -2605 16 963 964 981 982 -2606 17 963 964 981 985 -2607 18 965 964 981 982 -2608 19 965 964 981 985 -2609 53 963 968 969 971 -2610 54 963 968 969 973 -2611 54 963 968 969 974 -2612 54 963 968 970 975 -2613 54 963 968 970 976 -2614 54 963 968 970 977 -2615 55 969 968 970 975 -2616 55 969 968 970 976 -2617 55 969 968 970 977 -2618 56 970 968 969 971 -2619 55 970 968 969 973 -2620 55 970 968 969 974 -2621 12 972 968 969 971 -2622 13 972 968 969 973 -2623 13 972 968 969 974 -2624 13 972 968 970 975 -2625 13 972 968 970 976 -2626 13 972 968 970 977 -2627 21 968 969 971 978 -2628 21 968 969 971 979 -2629 21 968 969 971 980 -2630 23 973 969 971 978 -2631 23 973 969 971 979 -2632 23 973 969 971 980 -2633 23 974 969 971 978 -2634 23 974 969 971 979 -2635 23 974 969 971 980 -2636 26 964 981 982 983 -2637 27 964 981 982 986 -2638 28 964 981 982 987 -2639 29 985 981 982 983 -2640 30 985 981 982 986 -2641 31 985 981 982 987 -2642 32 981 982 983 984 -2643 33 981 982 983 998 -2644 34 981 982 987 988 -2645 35 981 982 987 992 -2646 35 981 982 987 993 -2647 8 983 982 987 988 -2648 9 983 982 987 992 -2649 9 983 982 987 993 -2650 10 986 982 983 984 -2651 11 986 982 983 998 -2652 12 986 982 987 988 -2653 13 986 982 987 992 -2654 13 986 982 987 993 -2655 14 987 982 983 984 -2656 15 987 982 983 998 -2657 16 982 983 998 999 -2658 17 982 983 998 1002 -2659 18 984 983 998 999 -2660 19 984 983 998 1002 -2661 36 982 987 988 989 -2662 21 982 987 988 994 -2663 21 982 987 988 995 -2664 37 992 987 988 989 -2665 23 992 987 988 994 -2666 23 992 987 988 995 -2667 37 993 987 988 989 -2668 23 993 987 988 994 -2669 23 993 987 988 995 -2670 38 987 988 989 990 -2671 39 987 988 989 991 -2672 40 994 988 989 990 -2673 41 994 988 989 991 -2674 40 995 988 989 990 -2675 41 995 988 989 991 -2676 42 988 989 991 996 -2677 42 988 989 991 997 -2678 19 990 989 991 996 -2679 19 990 989 991 997 -2680 26 983 998 999 1000 -2681 27 983 998 999 1003 -2682 28 983 998 999 1004 -2683 29 1002 998 999 1000 -2684 30 1002 998 999 1003 -2685 31 1002 998 999 1004 -2686 32 998 999 1000 1001 -2687 33 998 999 1000 1020 -2688 34 998 999 1004 1005 -2689 35 998 999 1004 1009 -2690 35 998 999 1004 1010 -2691 8 1000 999 1004 1005 -2692 9 1000 999 1004 1009 -2693 9 1000 999 1004 1010 -2694 10 1003 999 1000 1001 -2695 11 1003 999 1000 1020 -2696 12 1003 999 1004 1005 -2697 13 1003 999 1004 1009 -2698 13 1003 999 1004 1010 -2699 14 1004 999 1000 1001 -2700 15 1004 999 1000 1020 -2701 16 999 1000 1020 1021 -2702 17 999 1000 1020 1024 -2703 18 1001 1000 1020 1021 -2704 19 1001 1000 1020 1024 -2705 67 999 1004 1005 1006 -2706 21 999 1004 1005 1011 -2707 21 999 1004 1005 1012 -2708 68 1009 1004 1005 1006 -2709 23 1009 1004 1005 1011 -2710 23 1009 1004 1005 1012 -2711 68 1010 1004 1005 1006 -2712 23 1010 1004 1005 1011 -2713 23 1010 1004 1005 1012 -2714 69 1004 1005 1006 1007 -2715 68 1004 1005 1006 1013 -2716 68 1004 1005 1006 1014 -2717 68 1011 1005 1006 1007 -2718 23 1011 1005 1006 1013 -2719 23 1011 1005 1006 1014 -2720 68 1012 1005 1006 1007 -2721 23 1012 1005 1006 1013 -2722 23 1012 1005 1006 1014 -2723 70 1005 1006 1007 1008 -2724 68 1005 1006 1007 1015 -2725 68 1005 1006 1007 1016 -2726 71 1013 1006 1007 1008 -2727 23 1013 1006 1007 1015 -2728 23 1013 1006 1007 1016 -2729 71 1014 1006 1007 1008 -2730 23 1014 1006 1007 1015 -2731 23 1014 1006 1007 1016 -2732 72 1006 1007 1008 1017 -2733 72 1006 1007 1008 1018 -2734 72 1006 1007 1008 1019 -2735 73 1015 1007 1008 1017 -2736 73 1015 1007 1008 1018 -2737 73 1015 1007 1008 1019 -2738 73 1016 1007 1008 1017 -2739 73 1016 1007 1008 1018 -2740 73 1016 1007 1008 1019 -2741 26 1000 1020 1021 1022 -2742 27 1000 1020 1021 1025 -2743 28 1000 1020 1021 1026 -2744 29 1024 1020 1021 1022 -2745 30 1024 1020 1021 1025 -2746 31 1024 1020 1021 1026 -2747 32 1020 1021 1022 1023 -2748 33 1020 1021 1022 1035 -2749 34 1020 1021 1026 1027 -2750 35 1020 1021 1026 1031 -2751 35 1020 1021 1026 1032 -2752 8 1022 1021 1026 1027 -2753 9 1022 1021 1026 1031 -2754 9 1022 1021 1026 1032 -2755 10 1025 1021 1022 1023 -2756 11 1025 1021 1022 1035 -2757 12 1025 1021 1026 1027 -2758 13 1025 1021 1026 1031 -2759 13 1025 1021 1026 1032 -2760 14 1026 1021 1022 1023 -2761 15 1026 1021 1022 1035 -2762 16 1021 1022 1035 1036 -2763 17 1021 1022 1035 1039 -2764 18 1023 1022 1035 1036 -2765 19 1023 1022 1035 1039 -2766 97 1021 1026 1027 1028 -2767 21 1021 1026 1027 1033 -2768 21 1021 1026 1027 1034 -2769 98 1031 1026 1027 1028 -2770 23 1031 1026 1027 1033 -2771 23 1031 1026 1027 1034 -2772 98 1032 1026 1027 1028 -2773 23 1032 1026 1027 1033 -2774 23 1032 1026 1027 1034 -2775 99 1026 1027 1028 1029 -2776 99 1026 1027 1028 1030 -2777 100 1033 1027 1028 1029 -2778 100 1033 1027 1028 1030 -2779 100 1034 1027 1028 1029 -2780 100 1034 1027 1028 1030 -2781 26 1022 1035 1036 1037 -2782 27 1022 1035 1036 1040 -2783 28 1022 1035 1036 1041 -2784 29 1039 1035 1036 1037 -2785 30 1039 1035 1036 1040 -2786 31 1039 1035 1036 1041 -2787 32 1035 1036 1037 1038 -2788 33 1035 1036 1037 1046 -2789 136 1035 1036 1041 1042 -2790 35 1035 1036 1041 1043 -2791 35 1035 1036 1041 1044 -2792 137 1037 1036 1041 1042 -2793 9 1037 1036 1041 1043 -2794 9 1037 1036 1041 1044 -2795 10 1040 1036 1037 1038 -2796 11 1040 1036 1037 1046 -2797 138 1040 1036 1041 1042 -2798 13 1040 1036 1041 1043 -2799 13 1040 1036 1041 1044 -2800 14 1041 1036 1037 1038 -2801 15 1041 1036 1037 1046 -2802 16 1036 1037 1046 1047 -2803 17 1036 1037 1046 1050 -2804 18 1038 1037 1046 1047 -2805 19 1038 1037 1046 1050 -2806 139 1036 1041 1042 1045 -2807 140 1043 1041 1042 1045 -2808 140 1044 1041 1042 1045 -2809 26 1037 1046 1047 1048 -2810 27 1037 1046 1047 1051 -2811 43 1037 1046 1047 1052 -2812 29 1050 1046 1047 1048 -2813 30 1050 1046 1047 1051 -2814 44 1050 1046 1047 1052 -2815 32 1046 1047 1048 1049 -2816 33 1046 1047 1048 1060 -2817 74 1046 1047 1052 1053 -2818 45 1046 1047 1052 1054 -2819 46 1046 1047 1052 1055 -2820 75 1048 1047 1052 1053 -2821 47 1048 1047 1052 1054 -2822 48 1048 1047 1052 1055 -2823 10 1051 1047 1048 1049 -2824 11 1051 1047 1048 1060 -2825 76 1051 1047 1052 1053 -2826 49 1051 1047 1052 1054 -2827 50 1051 1047 1052 1055 -2828 51 1052 1047 1048 1049 -2829 52 1052 1047 1048 1060 -2830 16 1047 1048 1060 1061 -2831 17 1047 1048 1060 1064 -2832 18 1049 1048 1060 1061 -2833 19 1049 1048 1060 1064 -2834 77 1047 1052 1053 1056 -2835 54 1047 1052 1054 1057 -2836 54 1047 1052 1054 1058 -2837 54 1047 1052 1054 1059 -2838 78 1053 1052 1054 1057 -2839 78 1053 1052 1054 1058 -2840 78 1053 1052 1054 1059 -2841 79 1054 1052 1053 1056 -2842 80 1055 1052 1053 1056 -2843 13 1055 1052 1054 1057 -2844 13 1055 1052 1054 1058 -2845 13 1055 1052 1054 1059 -2846 26 1048 1060 1061 1062 -2847 27 1048 1060 1061 1065 -2848 28 1048 1060 1061 1066 -2849 29 1064 1060 1061 1062 -2850 30 1064 1060 1061 1065 -2851 31 1064 1060 1061 1066 -2852 32 1060 1061 1062 1063 -2853 33 1060 1061 1062 1079 -2854 81 1060 1061 1066 1067 -2855 35 1060 1061 1066 1070 -2856 35 1060 1061 1066 1071 -2857 82 1062 1061 1066 1067 -2858 9 1062 1061 1066 1070 -2859 9 1062 1061 1066 1071 -2860 10 1065 1061 1062 1063 -2861 11 1065 1061 1062 1079 -2862 83 1065 1061 1066 1067 -2863 13 1065 1061 1066 1070 -2864 13 1065 1061 1066 1071 -2865 14 1066 1061 1062 1063 -2866 15 1066 1061 1062 1079 -2867 16 1061 1062 1079 1080 -2868 17 1061 1062 1079 1083 -2869 18 1063 1062 1079 1080 -2870 19 1063 1062 1079 1083 -2871 84 1061 1066 1067 1068 -2872 84 1061 1066 1067 1069 -2873 83 1061 1066 1067 1072 -2874 55 1070 1066 1067 1068 -2875 55 1070 1066 1067 1069 -2876 13 1070 1066 1067 1072 -2877 55 1071 1066 1067 1068 -2878 55 1071 1066 1067 1069 -2879 13 1071 1066 1067 1072 -2880 55 1066 1067 1068 1073 -2881 55 1066 1067 1068 1074 -2882 55 1066 1067 1068 1075 -2883 55 1066 1067 1069 1076 -2884 55 1066 1067 1069 1077 -2885 55 1066 1067 1069 1078 -2886 55 1068 1067 1069 1076 -2887 55 1068 1067 1069 1077 -2888 55 1068 1067 1069 1078 -2889 55 1069 1067 1068 1073 -2890 55 1069 1067 1068 1074 -2891 55 1069 1067 1068 1075 -2892 13 1072 1067 1068 1073 -2893 13 1072 1067 1068 1074 -2894 13 1072 1067 1068 1075 -2895 13 1072 1067 1069 1076 -2896 13 1072 1067 1069 1077 -2897 13 1072 1067 1069 1078 -2898 26 1062 1079 1080 1081 -2899 27 1062 1079 1080 1084 -2900 28 1062 1079 1080 1085 -2901 29 1083 1079 1080 1081 -2902 30 1083 1079 1080 1084 -2903 31 1083 1079 1080 1085 -2904 32 1079 1080 1081 1082 -2905 33 1079 1080 1081 1097 -2906 164 1079 1080 1085 1086 -2907 35 1079 1080 1085 1091 -2908 35 1079 1080 1085 1092 -2909 165 1081 1080 1085 1086 -2910 9 1081 1080 1085 1091 -2911 9 1081 1080 1085 1092 -2912 10 1084 1080 1081 1082 -2913 11 1084 1080 1081 1097 -2914 166 1084 1080 1085 1086 -2915 13 1084 1080 1085 1091 -2916 13 1084 1080 1085 1092 -2917 14 1085 1080 1081 1082 -2918 15 1085 1080 1081 1097 -2919 16 1080 1081 1097 1098 -2920 17 1080 1081 1097 1101 -2921 18 1082 1081 1097 1098 -2922 19 1082 1081 1097 1101 -2923 167 1080 1085 1086 1087 -2924 168 1080 1085 1086 1088 -2925 169 1091 1085 1086 1087 -2926 170 1091 1085 1086 1088 -2927 169 1092 1085 1086 1087 -2928 170 1092 1085 1086 1088 -2929 171 1085 1086 1087 1089 -2930 172 1085 1086 1087 1093 -2931 173 1085 1086 1088 1090 -2932 174 1085 1086 1088 1094 -2933 175 1087 1086 1088 1090 -2934 176 1087 1086 1088 1094 -2935 177 1088 1086 1087 1089 -2936 178 1088 1086 1087 1093 -2937 179 1086 1087 1089 1090 -2938 180 1086 1087 1089 1095 -2939 181 1093 1087 1089 1090 -2940 182 1093 1087 1089 1095 -2941 177 1086 1088 1090 1089 -2942 178 1086 1088 1090 1096 -2943 183 1094 1088 1090 1089 -2944 184 1094 1088 1090 1096 -2945 179 1087 1089 1090 1088 -2946 181 1087 1089 1090 1096 -2947 180 1095 1089 1090 1088 -2948 182 1095 1089 1090 1096 -2949 26 1081 1097 1098 1099 -2950 27 1081 1097 1098 1102 -2951 28 1081 1097 1098 1103 -2952 29 1101 1097 1098 1099 -2953 30 1101 1097 1098 1102 -2954 31 1101 1097 1098 1103 -2955 32 1097 1098 1099 1100 -2956 33 1097 1098 1099 1116 -2957 81 1097 1098 1103 1104 -2958 35 1097 1098 1103 1107 -2959 35 1097 1098 1103 1108 -2960 82 1099 1098 1103 1104 -2961 9 1099 1098 1103 1107 -2962 9 1099 1098 1103 1108 -2963 10 1102 1098 1099 1100 -2964 11 1102 1098 1099 1116 -2965 83 1102 1098 1103 1104 -2966 13 1102 1098 1103 1107 -2967 13 1102 1098 1103 1108 -2968 14 1103 1098 1099 1100 -2969 15 1103 1098 1099 1116 -2970 16 1098 1099 1116 1117 -2971 17 1098 1099 1116 1120 -2972 18 1100 1099 1116 1117 -2973 19 1100 1099 1116 1120 -2974 84 1098 1103 1104 1105 -2975 84 1098 1103 1104 1106 -2976 83 1098 1103 1104 1109 -2977 55 1107 1103 1104 1105 -2978 55 1107 1103 1104 1106 -2979 13 1107 1103 1104 1109 -2980 55 1108 1103 1104 1105 -2981 55 1108 1103 1104 1106 -2982 13 1108 1103 1104 1109 -2983 55 1103 1104 1105 1110 -2984 55 1103 1104 1105 1111 -2985 55 1103 1104 1105 1112 -2986 55 1103 1104 1106 1113 -2987 55 1103 1104 1106 1114 -2988 55 1103 1104 1106 1115 -2989 55 1105 1104 1106 1113 -2990 55 1105 1104 1106 1114 -2991 55 1105 1104 1106 1115 -2992 55 1106 1104 1105 1110 -2993 55 1106 1104 1105 1111 -2994 55 1106 1104 1105 1112 -2995 13 1109 1104 1105 1110 -2996 13 1109 1104 1105 1111 -2997 13 1109 1104 1105 1112 -2998 13 1109 1104 1106 1113 -2999 13 1109 1104 1106 1114 -3000 13 1109 1104 1106 1115 -3001 26 1099 1116 1117 1118 -3002 27 1099 1116 1117 1121 -3003 43 1099 1116 1117 1122 -3004 29 1120 1116 1117 1118 -3005 30 1120 1116 1117 1121 -3006 44 1120 1116 1117 1122 -3007 32 1116 1117 1118 1119 -3008 33 1116 1117 1118 1132 -3009 45 1116 1117 1122 1123 -3010 45 1116 1117 1122 1124 -3011 46 1116 1117 1122 1125 -3012 47 1118 1117 1122 1123 -3013 47 1118 1117 1122 1124 -3014 48 1118 1117 1122 1125 -3015 10 1121 1117 1118 1119 -3016 11 1121 1117 1118 1132 -3017 49 1121 1117 1122 1123 -3018 49 1121 1117 1122 1124 -3019 50 1121 1117 1122 1125 -3020 51 1122 1117 1118 1119 -3021 52 1122 1117 1118 1132 -3022 16 1117 1118 1132 1133 -3023 17 1117 1118 1132 1136 -3024 18 1119 1118 1132 1133 -3025 19 1119 1118 1132 1136 -3026 54 1117 1122 1123 1126 -3027 54 1117 1122 1123 1127 -3028 54 1117 1122 1123 1128 -3029 54 1117 1122 1124 1129 -3030 54 1117 1122 1124 1130 -3031 54 1117 1122 1124 1131 -3032 55 1123 1122 1124 1129 -3033 55 1123 1122 1124 1130 -3034 55 1123 1122 1124 1131 -3035 55 1124 1122 1123 1126 -3036 55 1124 1122 1123 1127 -3037 55 1124 1122 1123 1128 -3038 13 1125 1122 1123 1126 -3039 13 1125 1122 1123 1127 -3040 13 1125 1122 1123 1128 -3041 13 1125 1122 1124 1129 -3042 13 1125 1122 1124 1130 -3043 13 1125 1122 1124 1131 -3044 26 1118 1132 1133 1134 -3045 27 1118 1132 1133 1137 -3046 28 1118 1132 1133 1138 -3047 29 1136 1132 1133 1134 -3048 30 1136 1132 1133 1137 -3049 31 1136 1132 1133 1138 -3050 32 1132 1133 1134 1135 -3051 33 1132 1133 1134 1151 -3052 81 1132 1133 1138 1139 -3053 35 1132 1133 1138 1142 -3054 35 1132 1133 1138 1143 -3055 82 1134 1133 1138 1139 -3056 9 1134 1133 1138 1142 -3057 9 1134 1133 1138 1143 -3058 10 1137 1133 1134 1135 -3059 11 1137 1133 1134 1151 -3060 83 1137 1133 1138 1139 -3061 13 1137 1133 1138 1142 -3062 13 1137 1133 1138 1143 -3063 14 1138 1133 1134 1135 -3064 15 1138 1133 1134 1151 -3065 16 1133 1134 1151 1152 -3066 17 1133 1134 1151 1155 -3067 18 1135 1134 1151 1152 -3068 19 1135 1134 1151 1155 -3069 84 1133 1138 1139 1140 -3070 84 1133 1138 1139 1141 -3071 83 1133 1138 1139 1144 -3072 55 1142 1138 1139 1140 -3073 55 1142 1138 1139 1141 -3074 13 1142 1138 1139 1144 -3075 55 1143 1138 1139 1140 -3076 55 1143 1138 1139 1141 -3077 13 1143 1138 1139 1144 -3078 55 1138 1139 1140 1145 -3079 55 1138 1139 1140 1146 -3080 55 1138 1139 1140 1147 -3081 55 1138 1139 1141 1148 -3082 55 1138 1139 1141 1149 -3083 55 1138 1139 1141 1150 -3084 55 1140 1139 1141 1148 -3085 55 1140 1139 1141 1149 -3086 55 1140 1139 1141 1150 -3087 55 1141 1139 1140 1145 -3088 55 1141 1139 1140 1146 -3089 55 1141 1139 1140 1147 -3090 13 1144 1139 1140 1145 -3091 13 1144 1139 1140 1146 -3092 13 1144 1139 1140 1147 -3093 13 1144 1139 1141 1148 -3094 13 1144 1139 1141 1149 -3095 13 1144 1139 1141 1150 -3096 26 1134 1151 1152 1153 -3097 27 1134 1151 1152 1156 -3098 28 1134 1151 1152 1157 -3099 29 1155 1151 1152 1153 -3100 30 1155 1151 1152 1156 -3101 31 1155 1151 1152 1157 -3102 32 1151 1152 1153 1154 -3103 33 1151 1152 1153 1175 -3104 34 1151 1152 1157 1158 -3105 35 1151 1152 1157 1164 -3106 35 1151 1152 1157 1165 -3107 8 1153 1152 1157 1158 -3108 9 1153 1152 1157 1164 -3109 9 1153 1152 1157 1165 -3110 10 1156 1152 1153 1154 -3111 11 1156 1152 1153 1175 -3112 12 1156 1152 1157 1158 -3113 13 1156 1152 1157 1164 -3114 13 1156 1152 1157 1165 -3115 14 1157 1152 1153 1154 -3116 15 1157 1152 1153 1175 -3117 16 1152 1153 1175 1176 -3118 17 1152 1153 1175 1179 -3119 18 1154 1153 1175 1176 -3120 19 1154 1153 1175 1179 -3121 67 1152 1157 1158 1159 -3122 21 1152 1157 1158 1166 -3123 21 1152 1157 1158 1167 -3124 68 1164 1157 1158 1159 -3125 23 1164 1157 1158 1166 -3126 23 1164 1157 1158 1167 -3127 68 1165 1157 1158 1159 -3128 23 1165 1157 1158 1166 -3129 23 1165 1157 1158 1167 -3130 153 1157 1158 1159 1160 -3131 68 1157 1158 1159 1168 -3132 68 1157 1158 1159 1169 -3133 154 1166 1158 1159 1160 -3134 23 1166 1158 1159 1168 -3135 23 1166 1158 1159 1169 -3136 154 1167 1158 1159 1160 -3137 23 1167 1158 1159 1168 -3138 23 1167 1158 1159 1169 -3139 155 1158 1159 1160 1161 -3140 156 1158 1159 1160 1170 -3141 157 1168 1159 1160 1161 -3142 158 1168 1159 1160 1170 -3143 157 1169 1159 1160 1161 -3144 158 1169 1159 1160 1170 -3145 159 1159 1160 1161 1162 -3146 159 1159 1160 1161 1163 -3147 160 1170 1160 1161 1162 -3148 160 1170 1160 1161 1163 -3149 160 1160 1161 1162 1171 -3150 160 1160 1161 1162 1172 -3151 160 1160 1161 1163 1173 -3152 160 1160 1161 1163 1174 -3153 160 1162 1161 1163 1173 -3154 160 1162 1161 1163 1174 -3155 160 1163 1161 1162 1171 -3156 160 1163 1161 1162 1172 -3157 26 1153 1175 1176 1177 -3158 27 1153 1175 1176 1180 -3159 28 1153 1175 1176 1181 -3160 29 1179 1175 1176 1177 -3161 30 1179 1175 1176 1180 -3162 31 1179 1175 1176 1181 -3163 32 1175 1176 1177 1178 -3164 33 1175 1176 1177 1194 -3165 81 1175 1176 1181 1182 -3166 35 1175 1176 1181 1185 -3167 35 1175 1176 1181 1186 -3168 82 1177 1176 1181 1182 -3169 9 1177 1176 1181 1185 -3170 9 1177 1176 1181 1186 -3171 10 1180 1176 1177 1178 -3172 11 1180 1176 1177 1194 -3173 83 1180 1176 1181 1182 -3174 13 1180 1176 1181 1185 -3175 13 1180 1176 1181 1186 -3176 14 1181 1176 1177 1178 -3177 15 1181 1176 1177 1194 -3178 16 1176 1177 1194 1195 -3179 17 1176 1177 1194 1198 -3180 18 1178 1177 1194 1195 -3181 19 1178 1177 1194 1198 -3182 84 1176 1181 1182 1183 -3183 84 1176 1181 1182 1184 -3184 83 1176 1181 1182 1187 -3185 55 1185 1181 1182 1183 -3186 55 1185 1181 1182 1184 -3187 13 1185 1181 1182 1187 -3188 55 1186 1181 1182 1183 -3189 55 1186 1181 1182 1184 -3190 13 1186 1181 1182 1187 -3191 55 1181 1182 1183 1188 -3192 55 1181 1182 1183 1189 -3193 55 1181 1182 1183 1190 -3194 55 1181 1182 1184 1191 -3195 55 1181 1182 1184 1192 -3196 55 1181 1182 1184 1193 -3197 55 1183 1182 1184 1191 -3198 55 1183 1182 1184 1192 -3199 55 1183 1182 1184 1193 -3200 55 1184 1182 1183 1188 -3201 55 1184 1182 1183 1189 -3202 55 1184 1182 1183 1190 -3203 13 1187 1182 1183 1188 -3204 13 1187 1182 1183 1189 -3205 13 1187 1182 1183 1190 -3206 13 1187 1182 1184 1191 -3207 13 1187 1182 1184 1192 -3208 13 1187 1182 1184 1193 -3209 26 1177 1194 1195 1196 -3210 27 1177 1194 1195 1199 -3211 28 1177 1194 1195 1200 -3212 29 1198 1194 1195 1196 -3213 30 1198 1194 1195 1199 -3214 31 1198 1194 1195 1200 -3215 32 1194 1195 1196 1197 -3216 33 1194 1195 1196 1218 -3217 34 1194 1195 1200 1201 -3218 35 1194 1195 1200 1207 -3219 35 1194 1195 1200 1208 -3220 8 1196 1195 1200 1201 -3221 9 1196 1195 1200 1207 -3222 9 1196 1195 1200 1208 -3223 10 1199 1195 1196 1197 -3224 11 1199 1195 1196 1218 -3225 12 1199 1195 1200 1201 -3226 13 1199 1195 1200 1207 -3227 13 1199 1195 1200 1208 -3228 14 1200 1195 1196 1197 -3229 15 1200 1195 1196 1218 -3230 85 1195 1196 1218 1219 -3231 17 1195 1196 1218 1222 -3232 86 1197 1196 1218 1219 -3233 19 1197 1196 1218 1222 -3234 67 1195 1200 1201 1202 -3235 21 1195 1200 1201 1209 -3236 21 1195 1200 1201 1210 -3237 68 1207 1200 1201 1202 -3238 23 1207 1200 1201 1209 -3239 23 1207 1200 1201 1210 -3240 68 1208 1200 1201 1202 -3241 23 1208 1200 1201 1209 -3242 23 1208 1200 1201 1210 -3243 153 1200 1201 1202 1203 -3244 68 1200 1201 1202 1211 -3245 68 1200 1201 1202 1212 -3246 154 1209 1201 1202 1203 -3247 23 1209 1201 1202 1211 -3248 23 1209 1201 1202 1212 -3249 154 1210 1201 1202 1203 -3250 23 1210 1201 1202 1211 -3251 23 1210 1201 1202 1212 -3252 155 1201 1202 1203 1204 -3253 156 1201 1202 1203 1213 -3254 157 1211 1202 1203 1204 -3255 158 1211 1202 1203 1213 -3256 157 1212 1202 1203 1204 -3257 158 1212 1202 1203 1213 -3258 159 1202 1203 1204 1205 -3259 159 1202 1203 1204 1206 -3260 160 1213 1203 1204 1205 -3261 160 1213 1203 1204 1206 -3262 160 1203 1204 1205 1214 -3263 160 1203 1204 1205 1215 -3264 160 1203 1204 1206 1216 -3265 160 1203 1204 1206 1217 -3266 160 1205 1204 1206 1216 -3267 160 1205 1204 1206 1217 -3268 160 1206 1204 1205 1214 -3269 160 1206 1204 1205 1215 -3270 87 1196 1218 1219 1220 -3271 88 1196 1218 1219 1223 -3272 88 1196 1218 1219 1224 -3273 89 1222 1218 1219 1220 -3274 90 1222 1218 1219 1223 -3275 90 1222 1218 1219 1224 -3276 91 1218 1219 1220 1221 -3277 92 1218 1219 1220 1225 -3278 93 1223 1219 1220 1221 -3279 94 1223 1219 1220 1225 -3280 93 1224 1219 1220 1221 -3281 94 1224 1219 1220 1225 -3282 185 1219 1220 1225 1226 -3283 96 1219 1220 1225 1229 -3284 86 1221 1220 1225 1226 -3285 19 1221 1220 1225 1229 -3286 186 1220 1225 1226 1227 -3287 88 1220 1225 1226 1230 -3288 88 1220 1225 1226 1231 -3289 187 1229 1225 1226 1227 -3290 90 1229 1225 1226 1230 -3291 90 1229 1225 1226 1231 -3292 188 1225 1226 1227 1228 -3293 188 1225 1226 1227 1232 -3294 189 1230 1226 1227 1228 -3295 189 1230 1226 1227 1232 -3296 189 1231 1226 1227 1228 -3297 189 1231 1226 1227 1232 - -Impropers - -1 1 2 3 4 20 -2 2 4 3 2 20 -3 3 20 3 2 4 -4 4 3 20 21 24 -5 5 21 20 3 24 -6 6 24 20 3 21 -7 1 21 22 23 37 -8 2 23 22 21 37 -9 3 37 22 21 23 -10 7 27 28 29 30 -11 2 29 28 27 30 -12 3 30 28 27 29 -13 4 28 30 35 36 -14 6 35 30 28 36 -15 6 36 30 28 35 -16 4 22 37 38 41 -17 5 38 37 22 41 -18 6 41 37 22 38 -19 1 38 39 40 56 -20 2 40 39 38 56 -21 3 56 39 38 40 -22 4 39 56 57 60 -23 5 57 56 39 60 -24 6 60 56 39 57 -25 1 57 58 59 76 -26 2 59 58 57 76 -27 3 76 58 57 59 -28 8 62 63 64 65 -29 9 64 63 62 65 -30 9 65 63 62 64 -31 9 63 64 66 71 -32 9 66 64 63 71 -33 10 71 64 63 66 -34 9 63 65 67 72 -35 9 67 65 63 72 -36 10 72 65 63 67 -37 9 64 66 68 73 -38 9 68 66 64 73 -39 10 73 66 64 68 -40 9 65 67 68 74 -41 9 68 67 65 74 -42 10 74 67 65 68 -43 9 66 68 67 75 -44 9 67 68 66 75 -45 10 75 68 66 67 -46 4 58 76 77 80 -47 5 77 76 58 80 -48 6 80 76 58 77 -49 1 77 78 79 92 -50 2 79 78 77 92 -51 3 92 78 77 79 -52 4 78 92 93 96 -53 5 93 92 78 96 -54 6 96 92 78 93 -55 1 93 94 95 114 -56 2 95 94 93 114 -57 3 114 94 93 95 -58 4 94 114 115 118 -59 5 115 114 94 118 -60 6 118 114 94 115 -61 1 115 116 117 128 -62 2 117 116 115 128 -63 3 128 116 115 117 -64 4 116 128 129 132 -65 5 129 128 116 132 -66 6 132 128 116 129 -67 1 129 130 131 147 -68 2 131 130 129 147 -69 3 147 130 129 131 -70 4 130 147 148 151 -71 5 148 147 130 151 -72 6 151 147 130 148 -73 1 148 149 150 161 -74 2 150 149 148 161 -75 3 161 149 148 150 -76 4 149 161 162 165 -77 11 162 161 149 165 -78 6 165 161 149 162 -79 12 162 163 164 168 -80 2 164 163 162 168 -81 3 168 163 162 164 -82 4 163 168 169 172 -83 5 169 168 163 172 -84 6 172 168 163 169 -85 1 169 170 171 190 -86 2 171 170 169 190 -87 3 190 170 169 171 -88 4 170 190 191 194 -89 5 191 190 170 194 -90 6 194 190 170 191 -91 1 191 192 193 204 -92 2 193 192 191 204 -93 3 204 192 191 193 -94 4 192 204 205 208 -95 5 205 204 192 208 -96 6 208 204 192 205 -97 1 205 206 207 223 -98 2 207 206 205 223 -99 3 223 206 205 207 -100 4 206 223 224 227 -101 5 224 223 206 227 -102 6 227 223 206 224 -103 1 224 225 226 237 -104 2 226 225 224 237 -105 3 237 225 224 226 -106 4 225 237 238 241 -107 5 238 237 225 241 -108 6 241 237 225 238 -109 1 238 239 240 256 -110 2 240 239 238 256 -111 3 256 239 238 240 -112 4 239 256 257 260 -113 5 257 256 239 260 -114 6 260 256 239 257 -115 1 257 258 259 271 -116 2 259 258 257 271 -117 3 271 258 257 259 -118 13 263 264 265 266 -119 14 265 264 263 266 -120 14 266 264 263 265 -121 4 258 271 272 275 -122 5 272 271 258 275 -123 6 275 271 258 272 -124 1 272 273 274 287 -125 2 274 273 272 287 -126 3 287 273 272 274 -127 4 273 287 288 291 -128 5 288 287 273 291 -129 6 291 287 273 288 -130 1 288 289 290 302 -131 2 290 289 288 302 -132 15 302 289 288 290 -133 13 294 295 296 297 -134 14 296 295 294 297 -135 14 297 295 294 296 -136 16 289 302 303 309 -137 17 303 302 289 309 -138 18 309 302 289 303 -139 1 303 304 305 316 -140 2 305 304 303 316 -141 3 316 304 303 305 -142 4 304 316 317 320 -143 5 317 316 304 320 -144 6 320 316 304 317 -145 1 317 318 319 327 -146 2 319 318 317 327 -147 3 327 318 317 319 -148 4 318 327 328 331 -149 5 328 327 318 331 -150 6 331 327 318 328 -151 1 328 329 330 339 -152 2 330 329 328 339 -153 3 339 329 328 330 -154 13 333 334 335 336 -155 14 335 334 333 336 -156 14 336 334 333 335 -157 4 329 339 340 343 -158 5 340 339 329 343 -159 6 343 339 329 340 -160 1 340 341 342 353 -161 2 342 341 340 353 -162 3 353 341 340 342 -163 4 341 353 354 357 -164 5 354 353 341 357 -165 6 357 353 341 354 -166 1 354 355 356 372 -167 2 356 355 354 372 -168 3 372 355 354 356 -169 4 355 372 373 376 -170 5 373 372 355 376 -171 6 376 372 355 373 -172 1 373 374 375 387 -173 2 375 374 373 387 -174 3 387 374 373 375 -175 13 379 380 381 382 -176 14 381 380 379 382 -177 14 382 380 379 381 -178 4 374 387 388 391 -179 5 388 387 374 391 -180 6 391 387 374 388 -181 1 388 389 390 401 -182 2 390 389 388 401 -183 3 401 389 388 390 -184 7 393 394 395 396 -185 2 395 394 393 396 -186 3 396 394 393 395 -187 4 394 396 399 400 -188 6 399 396 394 400 -189 6 400 396 394 399 -190 4 389 401 402 405 -191 5 402 401 389 405 -192 6 405 401 389 402 -193 1 402 403 404 417 -194 2 404 403 402 417 -195 3 417 403 402 404 -196 4 403 417 418 421 -197 5 418 417 403 421 -198 6 421 417 403 418 -199 1 418 419 420 439 -200 2 420 419 418 439 -201 3 439 419 418 420 -202 4 419 439 440 443 -203 5 440 439 419 443 -204 6 443 439 419 440 -205 1 440 441 442 449 -206 2 442 441 440 449 -207 3 449 441 440 442 -208 4 441 449 450 453 -209 5 450 449 441 453 -210 6 453 449 441 450 -211 1 450 451 452 471 -212 2 452 451 450 471 -213 3 471 451 450 452 -214 4 451 471 472 475 -215 5 472 471 451 475 -216 6 475 471 451 472 -217 1 472 473 474 490 -218 2 474 473 472 490 -219 3 490 473 472 474 -220 4 473 490 491 494 -221 5 491 490 473 494 -222 6 494 490 473 491 -223 1 491 492 493 507 -224 2 493 492 491 507 -225 3 507 492 491 493 -226 7 497 498 499 500 -227 2 499 498 497 500 -228 3 500 498 497 499 -229 4 498 500 505 506 -230 6 505 500 498 506 -231 6 506 500 498 505 -232 4 492 507 508 511 -233 5 508 507 492 511 -234 6 511 507 492 508 -235 1 508 509 510 519 -236 2 510 509 508 519 -237 3 519 509 508 510 -238 13 513 514 515 516 -239 14 515 514 513 516 -240 14 516 514 513 515 -241 4 509 519 520 523 -242 5 520 519 509 523 -243 6 523 519 509 520 -244 1 520 521 522 541 -245 2 522 521 520 541 -246 3 541 521 520 522 -247 4 521 541 542 545 -248 5 542 541 521 545 -249 6 545 541 521 542 -250 1 542 543 544 556 -251 2 544 543 542 556 -252 3 556 543 542 544 -253 13 548 549 550 551 -254 14 550 549 548 551 -255 14 551 549 548 550 -256 4 543 556 557 560 -257 11 557 556 543 560 -258 6 560 556 543 557 -259 12 557 558 559 563 -260 2 559 558 557 563 -261 3 563 558 557 559 -262 4 558 563 564 567 -263 5 564 563 558 567 -264 6 567 563 558 564 -265 1 564 565 566 582 -266 2 566 565 564 582 -267 15 582 565 564 566 -268 16 565 582 583 589 -269 17 583 582 565 589 -270 18 589 582 565 583 -271 1 583 584 585 596 -272 2 585 584 583 596 -273 15 596 584 583 585 -274 16 584 596 597 603 -275 17 597 596 584 603 -276 18 603 596 584 597 -277 1 597 598 599 610 -278 2 599 598 597 610 -279 3 610 598 597 599 -280 4 598 610 611 614 -281 5 611 610 598 614 -282 6 614 610 598 611 -283 1 611 612 613 622 -284 2 613 612 611 622 -285 3 622 612 611 613 -286 13 616 617 618 619 -287 14 618 617 616 619 -288 14 619 617 616 618 -289 4 612 622 623 626 -290 5 623 622 612 626 -291 6 626 622 612 623 -292 1 623 624 625 639 -293 2 625 624 623 639 -294 3 639 624 623 625 -295 7 629 630 631 632 -296 2 631 630 629 632 -297 3 632 630 629 631 -298 4 630 632 637 638 -299 6 637 632 630 638 -300 6 638 632 630 637 -301 4 624 639 640 643 -302 5 640 639 624 643 -303 6 643 639 624 640 -304 1 640 641 642 656 -305 2 642 641 640 656 -306 3 656 641 640 642 -307 7 646 647 648 649 -308 2 648 647 646 649 -309 3 649 647 646 648 -310 4 647 649 654 655 -311 6 654 649 647 655 -312 6 655 649 647 654 -313 4 641 656 657 660 -314 5 657 656 641 660 -315 6 660 656 641 657 -316 1 657 658 659 680 -317 2 659 658 657 680 -318 3 680 658 657 659 -319 19 664 665 666 675 -320 20 666 665 664 675 -321 21 675 665 664 666 -322 22 665 666 667 668 -323 22 667 666 665 668 -324 22 668 666 665 667 -325 20 666 667 676 677 -326 21 676 667 666 677 -327 21 677 667 666 676 -328 20 666 668 678 679 -329 21 678 668 666 679 -330 21 679 668 666 678 -331 4 658 680 681 684 -332 5 681 680 658 684 -333 6 684 680 658 681 -334 1 681 682 683 699 -335 2 683 682 681 699 -336 3 699 682 681 683 -337 4 682 699 700 703 -338 5 700 699 682 703 -339 6 703 699 682 700 -340 1 700 701 702 718 -341 2 702 701 700 718 -342 3 718 701 700 702 -343 4 701 718 719 722 -344 5 719 718 701 722 -345 6 722 718 701 719 -346 1 719 720 721 738 -347 2 721 720 719 738 -348 3 738 720 719 721 -349 8 724 725 726 727 -350 9 726 725 724 727 -351 9 727 725 724 726 -352 9 725 726 728 733 -353 9 728 726 725 733 -354 10 733 726 725 728 -355 9 725 727 729 734 -356 9 729 727 725 734 -357 10 734 727 725 729 -358 9 726 728 730 735 -359 9 730 728 726 735 -360 10 735 728 726 730 -361 9 727 729 730 736 -362 9 730 729 727 736 -363 10 736 729 727 730 -364 9 728 730 729 737 -365 9 729 730 728 737 -366 10 737 730 728 729 -367 4 720 738 739 742 -368 5 739 738 720 742 -369 6 742 738 720 739 -370 1 739 740 741 748 -371 2 741 740 739 748 -372 3 748 740 739 741 -373 4 740 748 749 752 -374 11 749 748 740 752 -375 6 752 748 740 749 -376 12 749 750 751 755 -377 2 751 750 749 755 -378 3 755 750 749 751 -379 4 750 755 756 759 -380 5 756 755 750 759 -381 6 759 755 750 756 -382 1 756 757 758 777 -383 2 758 757 756 777 -384 3 777 757 756 758 -385 4 757 777 778 781 -386 5 778 777 757 781 -387 6 781 777 757 778 -388 1 778 779 780 794 -389 2 780 779 778 794 -390 3 794 779 778 780 -391 7 784 785 786 787 -392 2 786 785 784 787 -393 3 787 785 784 786 -394 4 785 787 792 793 -395 6 792 787 785 793 -396 6 793 787 785 792 -397 4 779 794 795 798 -398 5 795 794 779 798 -399 6 798 794 779 795 -400 1 795 796 797 813 -401 2 797 796 795 813 -402 3 813 796 795 797 -403 4 796 813 814 817 -404 5 814 813 796 817 -405 6 817 813 796 814 -406 1 814 815 816 828 -407 2 816 815 814 828 -408 3 828 815 814 816 -409 13 820 821 822 823 -410 14 822 821 820 823 -411 14 823 821 820 822 -412 4 815 828 829 832 -413 5 829 828 815 832 -414 6 832 828 815 829 -415 1 829 830 831 840 -416 2 831 830 829 840 -417 3 840 830 829 831 -418 13 834 835 836 837 -419 14 836 835 834 837 -420 14 837 835 834 836 -421 4 830 840 841 844 -422 11 841 840 830 844 -423 6 844 840 830 841 -424 12 841 842 843 847 -425 2 843 842 841 847 -426 3 847 842 841 843 -427 4 842 847 848 851 -428 5 848 847 842 851 -429 6 851 847 842 848 -430 1 848 849 850 871 -431 2 850 849 848 871 -432 3 871 849 848 850 -433 19 855 856 857 866 -434 20 857 856 855 866 -435 21 866 856 855 857 -436 22 856 857 858 859 -437 22 858 857 856 859 -438 22 859 857 856 858 -439 20 857 858 867 868 -440 21 867 858 857 868 -441 21 868 858 857 867 -442 20 857 859 869 870 -443 21 869 859 857 870 -444 21 870 859 857 869 -445 4 849 871 872 875 -446 5 872 871 849 875 -447 6 875 871 849 872 -448 1 872 873 874 885 -449 2 874 873 872 885 -450 3 885 873 872 874 -451 4 873 885 886 889 -452 5 886 885 873 889 -453 6 889 885 873 886 -454 1 886 887 888 904 -455 2 888 887 886 904 -456 3 904 887 886 888 -457 4 887 904 905 908 -458 5 905 904 887 908 -459 6 908 904 887 905 -460 1 905 906 907 915 -461 2 907 906 905 915 -462 3 915 906 905 907 -463 4 906 915 916 919 -464 5 916 915 906 919 -465 6 919 915 906 916 -466 1 916 917 918 927 -467 2 918 917 916 927 -468 3 927 917 916 918 -469 13 921 922 923 924 -470 14 923 922 921 924 -471 14 924 922 921 923 -472 4 917 927 928 931 -473 5 928 927 917 931 -474 6 931 927 917 928 -475 1 928 929 930 948 -476 2 930 929 928 948 -477 3 948 929 928 930 -478 8 933 934 935 936 -479 9 935 934 933 936 -480 9 936 934 933 935 -481 9 934 935 937 943 -482 9 937 935 934 943 -483 10 943 935 934 937 -484 9 934 936 938 944 -485 9 938 936 934 944 -486 10 944 936 934 938 -487 9 935 937 939 945 -488 9 939 937 935 945 -489 10 945 937 935 939 -490 9 936 938 939 946 -491 9 939 938 936 946 -492 10 946 938 936 939 -493 9 937 939 938 940 -494 9 938 939 937 940 -495 23 940 939 937 938 -496 4 929 948 949 952 -497 5 949 948 929 952 -498 6 952 948 929 949 -499 1 949 950 951 962 -500 2 951 950 949 962 -501 3 962 950 949 951 -502 7 954 955 956 957 -503 2 956 955 954 957 -504 3 957 955 954 956 -505 4 955 957 960 961 -506 6 960 957 955 961 -507 6 961 957 955 960 -508 4 950 962 963 966 -509 5 963 962 950 966 -510 6 966 962 950 963 -511 1 963 964 965 981 -512 2 965 964 963 981 -513 3 981 964 963 965 -514 4 964 981 982 985 -515 5 982 981 964 985 -516 6 985 981 964 982 -517 1 982 983 984 998 -518 2 984 983 982 998 -519 3 998 983 982 984 -520 7 988 989 990 991 -521 2 990 989 988 991 -522 3 991 989 988 990 -523 4 989 991 996 997 -524 6 996 991 989 997 -525 6 997 991 989 996 -526 4 983 998 999 1002 -527 5 999 998 983 1002 -528 6 1002 998 983 999 -529 1 999 1000 1001 1020 -530 2 1001 1000 999 1020 -531 3 1020 1000 999 1001 -532 4 1000 1020 1021 1024 -533 5 1021 1020 1000 1024 -534 6 1024 1020 1000 1021 -535 1 1021 1022 1023 1035 -536 2 1023 1022 1021 1035 -537 3 1035 1022 1021 1023 -538 13 1027 1028 1029 1030 -539 14 1029 1028 1027 1030 -540 14 1030 1028 1027 1029 -541 4 1022 1035 1036 1039 -542 5 1036 1035 1022 1039 -543 6 1039 1035 1022 1036 -544 1 1036 1037 1038 1046 -545 2 1038 1037 1036 1046 -546 3 1046 1037 1036 1038 -547 4 1037 1046 1047 1050 -548 5 1047 1046 1037 1050 -549 6 1050 1046 1037 1047 -550 1 1047 1048 1049 1060 -551 2 1049 1048 1047 1060 -552 3 1060 1048 1047 1049 -553 4 1048 1060 1061 1064 -554 5 1061 1060 1048 1064 -555 6 1064 1060 1048 1061 -556 1 1061 1062 1063 1079 -557 2 1063 1062 1061 1079 -558 3 1079 1062 1061 1063 -559 4 1062 1079 1080 1083 -560 5 1080 1079 1062 1083 -561 6 1083 1079 1062 1080 -562 1 1080 1081 1082 1097 -563 2 1082 1081 1080 1097 -564 3 1097 1081 1080 1082 -565 24 1085 1086 1087 1088 -566 25 1087 1086 1085 1088 -567 26 1088 1086 1085 1087 -568 27 1086 1087 1089 1093 -569 28 1089 1087 1086 1093 -570 29 1093 1087 1086 1089 -571 26 1086 1088 1090 1094 -572 25 1090 1088 1086 1094 -573 30 1094 1088 1086 1090 -574 31 1087 1089 1090 1095 -575 31 1090 1089 1087 1095 -576 32 1095 1089 1087 1090 -577 27 1088 1090 1089 1096 -578 28 1089 1090 1088 1096 -579 29 1096 1090 1088 1089 -580 4 1081 1097 1098 1101 -581 5 1098 1097 1081 1101 -582 6 1101 1097 1081 1098 -583 1 1098 1099 1100 1116 -584 2 1100 1099 1098 1116 -585 3 1116 1099 1098 1100 -586 4 1099 1116 1117 1120 -587 5 1117 1116 1099 1120 -588 6 1120 1116 1099 1117 -589 1 1117 1118 1119 1132 -590 2 1119 1118 1117 1132 -591 3 1132 1118 1117 1119 -592 4 1118 1132 1133 1136 -593 5 1133 1132 1118 1136 -594 6 1136 1132 1118 1133 -595 1 1133 1134 1135 1151 -596 2 1135 1134 1133 1151 -597 3 1151 1134 1133 1135 -598 4 1134 1151 1152 1155 -599 5 1152 1151 1134 1155 -600 6 1155 1151 1134 1152 -601 1 1152 1153 1154 1175 -602 2 1154 1153 1152 1175 -603 3 1175 1153 1152 1154 -604 19 1159 1160 1161 1170 -605 20 1161 1160 1159 1170 -606 21 1170 1160 1159 1161 -607 22 1160 1161 1162 1163 -608 22 1162 1161 1160 1163 -609 22 1163 1161 1160 1162 -610 20 1161 1162 1171 1172 -611 21 1171 1162 1161 1172 -612 21 1172 1162 1161 1171 -613 20 1161 1163 1173 1174 -614 21 1173 1163 1161 1174 -615 21 1174 1163 1161 1173 -616 4 1153 1175 1176 1179 -617 5 1176 1175 1153 1179 -618 6 1179 1175 1153 1176 -619 1 1176 1177 1178 1194 -620 2 1178 1177 1176 1194 -621 3 1194 1177 1176 1178 -622 4 1177 1194 1195 1198 -623 5 1195 1194 1177 1198 -624 6 1198 1194 1177 1195 -625 1 1195 1196 1197 1218 -626 2 1197 1196 1195 1218 -627 3 1218 1196 1195 1197 -628 19 1202 1203 1204 1213 -629 20 1204 1203 1202 1213 -630 21 1213 1203 1202 1204 -631 22 1203 1204 1205 1206 -632 22 1205 1204 1203 1206 -633 22 1206 1204 1203 1205 -634 20 1204 1205 1214 1215 -635 21 1214 1205 1204 1215 -636 21 1215 1205 1204 1214 -637 20 1204 1206 1216 1217 -638 21 1216 1206 1204 1217 -639 21 1217 1206 1204 1216 -640 4 1196 1218 1219 1222 -641 11 1219 1218 1196 1222 -642 6 1222 1218 1196 1219 -643 12 1219 1220 1221 1225 -644 2 1221 1220 1219 1225 -645 3 1225 1220 1219 1221 -646 4 1220 1225 1226 1229 -647 11 1226 1225 1220 1229 -648 6 1229 1225 1220 1226 -649 33 1226 1227 1228 1232 -650 14 1228 1227 1226 1232 -651 14 1232 1227 1226 1228 - -Bond Coeffs - -1 1.448 381.3 -972.315 1446.3185625 -2 1.015 461.9 -1177.845 1752.0444375 -3 1.509 345.0 -879.75 1308.628125 -4 1.112 341.0 -869.55 1293.455625 -5 1.525 323.0 -823.65 1225.179375 -6 1.2255 662.0 -1688.1 2511.04875 -7 1.345 482.0 -1229.1 1828.28625 -8 1.525 323.0 -823.65 1225.179375 -9 1.112 341.0 -869.55 1293.455625 -10 1.805 215.8 -550.29 818.556375 -11 1.437 375.0 -956.25 1422.421875 -12 1.028 487.0 -1241.85 1847.251875 -13 1.509 345.0 -879.75 1308.628125 -14 1.525 323.0 -823.65 1225.179375 -15 1.499 453.2 -1155.66 1719.04425 -16 1.3887 471.9 -1203.345 1789.9756875 -17 1.1 370.5 -944.775 1405.3528125 -18 1.448 381.3 -972.315 1446.3185625 -19 1.015 461.9 -1177.845 1752.0444375 -20 1.413 410.0 -1045.5 1555.18125 -21 0.947 548.9 -1399.695 2082.0463125 -22 1.437 375.0 -956.25 1422.421875 -23 1.509 345.0 -879.75 1308.628125 -24 1.112 341.0 -869.55 1293.455625 -25 1.509 345.0 -879.75 1308.628125 -26 1.2553 705.0 -1797.75 2674.153125 -27 1.345 482.0 -1229.1 1828.28625 -28 1.437 375.0 -956.25 1422.421875 -29 1.437 375.0 -956.25 1422.421875 -30 1.525 323.0 -823.65 1225.179375 -31 1.5247 323.0 -823.65 1225.179375 -32 1.112 341.0 -869.55 1293.455625 -33 1.112 341.0 -869.55 1293.455625 -34 1.413 410.0 -1045.5 1555.18125 -35 1.446 374.8 -955.74 1421.66325 -36 1.325 491.4 -1253.07 1863.941625 -37 1.028 487.0 -1241.85 1847.251875 -38 1.355 431.6 -1100.58 1637.11275 -39 0.947 548.9 -1399.695 2082.0463125 -40 1.493 453.2 -1155.66 1719.04425 -41 1.373 653.9 -1667.445 2480.3244375 -42 1.371 539.6 -1375.98 2046.77025 -43 1.352 653.9 -1667.445 2480.3244375 -44 1.03 467.6 -1192.38 1773.66525 -45 1.081 370.5 -944.775 1405.3528125 -46 1.081 370.5 -944.775 1405.3528125 -47 1.509 345.0 -879.75 1308.628125 -48 0.9572 556.85 -1419.9675 2112.20165625 -49 -7.6 1.5537 0.0 0.0 - -Angle Coeffs - -1 0 108.5 43.2 -34.6524874495 7.94176512195 -5.68787029215 10.2422873821 -2 0 105.4 43.2 -34.6524874495 7.94176512195 -5.68787029215 10.2422873821 -3 0 110.7 75.2 -60.3209966714 13.8245541012 -9.90110754559 17.8291669244 -4 0 109.3 59.0 -47.3263138778 10.8463921804 -7.76815618604 13.9883091561 -5 0 110.7 75.2 -60.3209966714 13.8245541012 -9.90110754559 17.8291669244 -6 0 109.5 39.0 -31.2834956141 7.16964906843 -5.13488290263 9.24650944218 -7 0 110.6 58.0 -46.5241729646 10.6625550248 -7.63649252187 13.7512191704 -8 0 112.8 42.0 -33.6899183537 7.72116053523 -5.52987389514 9.95777939927 -9 1 122.4 80.0 -64.1712730547 14.7069724481 -10.5330931336 18.9671988558 -10 1 113.4 70.0 -56.1498639228 12.868600892 -9.21645649191 16.5962989988 -11 1 124.2 77.0 -61.7648503151 14.1554609813 -10.1381021411 18.2559288987 -12 0 111.0 48.2 -38.6631920154 8.86095089995 -6.346188613 11.4277373106 -13 0 110.7 42.0 -33.6899183537 7.72116053523 -5.52987389514 9.95777939927 -14 0 110.7 42.0 -33.6899183537 7.72116053523 -5.52987389514 9.95777939927 -15 0 107.8 40.0 -32.0856365273 7.35348622403 -5.2665465668 9.48359942788 -16 0 110.1 53.2 -42.6738965813 9.78013667795 -7.00450693385 12.6131872391 -17 0 110.8 53.2 -42.6738965813 9.78013667795 -7.00450693385 12.6131872391 -18 0 95.9 60.4 -48.4493111563 11.1037641983 -7.95248531587 14.3202351361 -19 0 108.0 53.2 -42.6738965813 9.78013667795 -7.00450693385 12.6131872391 -20 1 122.0 50.0 -40.1070456592 9.19185778003 -6.5831832085 11.8544992848 -21 1 121.0 36.0 -28.8770728746 6.61813760162 -4.73989191012 8.53523948509 -22 1 117.0 32.0 -25.6685092219 5.88278897922 -4.21323725344 7.5868795423 -23 0 109.6 61.0 -48.9305957042 11.2140664916 -8.03148351438 14.4624891275 -24 0 111.0 55.0 -44.1177502251 10.111043558 -7.24150152936 13.0399492133 -25 0 111.3 54.0 -43.3156093119 9.92720640244 -7.10983786519 12.8028592276 -26 0 110.6 47.6 -38.1819074675 8.75064860659 -6.2671904145 11.2854833192 -27 0 109.5 39.0 -31.2834956141 7.16964906843 -5.13488290263 9.24650944218 -28 1 122.4 80.0 -64.1712730547 14.7069724481 -10.5330931336 18.9671988558 -29 1 113.4 70.0 -56.1498639228 12.868600892 -9.21645649191 16.5962989988 -30 1 123.0 29.5 -23.6631569389 5.42319609022 -3.88407809302 6.99415457806 -31 0 111.3 54.0 -43.3156093119 9.92720640244 -7.10983786519 12.8028592276 -32 0 110.6 58.0 -46.5241729646 10.6625550248 -7.63649252187 13.7512191704 -33 0 110.7 42.0 -33.6899183537 7.72116053523 -5.52987389514 9.95777939927 -34 0 110.2 48.2 -38.6631920154 8.86095089995 -6.346188613 11.4277373106 -35 0 110.2 48.2 -38.6631920154 8.86095089995 -6.346188613 11.4277373106 -36 0 110.6 38.9 -31.2032815228 7.15126535287 -5.12171653622 9.22280044361 -37 0 109.3 39.6 -31.7647801621 7.27995136179 -5.21388110114 9.3887634336 -38 1 122.3 33.8 -27.1123628656 6.2136958593 -4.45023184895 8.01364151656 -39 1 121.7 54.7 -43.8771079511 10.0558924114 -7.2020024301 12.9688222176 -40 1 120.0 35.3 -28.3155742354 6.4894515927 -4.6477273452 8.3692764951 -41 0 111.0 48.2 -38.6631920154 8.86095089995 -6.346188613 11.4277373106 -42 0 109.5 56.1 -45.0001052296 10.3132644292 -7.38633155994 13.3007481976 -43 0 109.3 59.0 -47.3263138778 10.8463921804 -7.76815618604 13.9883091561 -44 0 110.9 43.2 -34.6524874495 7.94176512195 -5.68787029215 10.2422873821 -45 0 107.0 43.5 -34.8931297235 7.99691626863 -5.7273693914 10.3134143778 -46 0 107.5 59.7 -47.887812517 10.9750781894 -7.86032075095 14.1542721461 -47 0 107.5 59.7 -47.887812517 10.9750781894 -7.86032075095 14.1542721461 -48 0 110.0 59.0 -47.3263138778 10.8463921804 -7.76815618604 13.9883091561 -49 0 106.8 54.0 -43.3156093119 9.92720640244 -7.10983786519 12.8028592276 -50 0 111.0 48.2 -38.6631920154 8.86095089995 -6.346188613 11.4277373106 -51 1 122.0 50.0 -40.1070456592 9.19185778003 -6.5831832085 11.8544992848 -52 1 117.0 32.0 -25.6685092219 5.88278897922 -4.21323725344 7.5868795423 -53 0 109.8 55.0 -44.1177502251 10.111043558 -7.24150152936 13.0399492133 -54 0 111.0 55.0 -44.1177502251 10.111043558 -7.24150152936 13.0399492133 -55 0 109.5 39.0 -31.2834956141 7.16964906843 -5.13488290263 9.24650944218 -56 0 107.6 40.0 -32.0856365273 7.35348622403 -5.2665465668 9.48359942788 -57 1 122.4 80.0 -64.1712730547 14.7069724481 -10.5330931336 18.9671988558 -58 1 113.4 70.0 -56.1498639228 12.868600892 -9.21645649191 16.5962989988 -59 0 110.6 47.6 -38.1819074675 8.75064860659 -6.2671904145 11.2854833192 -60 0 109.5 39.0 -31.2834956141 7.16964906843 -5.13488290263 9.24650944218 -61 1 122.4 80.0 -64.1712730547 14.7069724481 -10.5330931336 18.9671988558 -62 1 134.0 57.6 -46.2033165993 10.5890201626 -7.5838270562 13.6563831761 -63 1 113.4 70.0 -56.1498639228 12.868600892 -9.21645649191 16.5962989988 -64 1 124.2 77.0 -61.7648503151 14.1554609813 -10.1381021411 18.2559288987 -65 1 122.0 50.0 -40.1070456592 9.19185778003 -6.5831832085 11.8544992848 -66 1 122.0 50.0 -40.1070456592 9.19185778003 -6.5831832085 11.8544992848 -67 1 112.5 54.7 -43.8771079511 10.0558924114 -7.2020024301 12.9688222176 -68 0 109.6 61.0 -48.9305957042 11.2140664916 -8.03148351438 14.4624891275 -69 0 111.0 55.0 -44.1177502251 10.111043558 -7.24150152936 13.0399492133 -70 0 104.0 54.0 -43.3156093119 9.92720640244 -7.10983786519 12.8028592276 -71 0 110.6 58.0 -46.5241729646 10.6625550248 -7.63649252187 13.7512191704 -72 0 112.8 42.0 -33.6899183537 7.72116053523 -5.52987389514 9.95777939927 -73 0 104.0 48.2 -38.6631920154 8.86095089995 -6.346188613 11.4277373106 -74 0 110.7 42.0 -33.6899183537 7.72116053523 -5.52987389514 9.95777939927 -75 0 110.7 42.0 -33.6899183537 7.72116053523 -5.52987389514 9.95777939927 -76 0 107.8 40.0 -32.0856365273 7.35348622403 -5.2665465668 9.48359942788 -77 0 104.0 48.2 -38.6631920154 8.86095089995 -6.346188613 11.4277373106 -78 0 104.0 54.0 -43.3156093119 9.92720640244 -7.10983786519 12.8028592276 -79 0 111.0 55.0 -44.1177502251 10.111043558 -7.24150152936 13.0399492133 -80 0 110.7 42.0 -33.6899183537 7.72116053523 -5.52987389514 9.95777939927 -81 0 107.8 40.0 -32.0856365273 7.35348622403 -5.2665465668 9.48359942788 -82 0 107.5 59.7 -47.887812517 10.9750781894 -7.86032075095 14.1542721461 -83 0 108.9 59.0 -47.3263138778 10.8463921804 -7.76815618604 13.9883091561 -84 0 106.8 54.0 -43.3156093119 9.92720640244 -7.10983786519 12.8028592276 -85 0 110.6 47.6 -38.1819074675 8.75064860659 -6.2671904145 11.2854833192 -86 0 110.6 47.6 -38.1819074675 8.75064860659 -6.2671904145 11.2854833192 -87 0 109.5 56.1 -45.0001052296 10.3132644292 -7.38633155994 13.3007481976 -88 0 111.0 54.6 -43.7968938598 10.0375086958 -7.18883606369 12.9451132191 -89 1 120.4 52.5 -42.1123979421 9.65145066903 -6.91234236893 12.4472242491 -90 1 122.4 13.7 -10.9893305106 2.51856903173 -1.80379219913 3.24813280405 -91 1 120.5 41.7 -33.4492760797 7.66600938855 -5.49037479589 9.88665240356 -92 1 120.0 28.8 -23.1016582997 5.2945100813 -3.7919135281 6.82819158807 -93 1 120.0 29.5 -23.6631569389 5.42319609022 -3.88407809302 6.99415457806 -94 1 120.0 43.2 -34.6524874495 7.94176512195 -5.68787029215 10.2422873821 -95 0 109.0 25.9 -20.7754496514 4.76138233006 -3.41008890201 6.14063062955 -96 0 112.7 38.8 -31.1230674315 7.13288163731 -5.1085501698 9.19909144504 -97 0 109.5 39.6 -31.7647801621 7.27995136179 -5.21388110114 9.3887634336 -98 1 122.0 36.0 -28.8770728746 6.61813760162 -4.73989191012 8.53523948509 -99 1 131.0 36.0 -28.8770728746 6.61813760162 -4.73989191012 8.53523948509 -100 1 104.7 47.5 -38.1016933762 8.73226489103 -6.25402404808 11.2617743206 -101 1 110.8 86.3 -69.2247608077 15.8651465283 -11.3625742179 20.4608657656 -102 1 125.5 35.3 -28.3155742354 6.4894515927 -4.6477273452 8.3692764951 -103 1 125.5 35.3 -28.3155742354 6.4894515927 -4.6477273452 8.3692764951 -104 1 128.0 35.3 -28.3155742354 6.4894515927 -4.6477273452 8.3692764951 -105 1 122.5 38.1 -30.5615687923 7.00419562839 -5.01638560488 9.03312845505 -106 1 110.3 28.8 -23.1016582997 5.2945100813 -3.7919135281 6.82819158807 -107 1 122.5 38.1 -30.5615687923 7.00419562839 -5.01638560488 9.03312845505 -108 0 109.6 61.0 -48.9305957042 11.2140664916 -8.03148351438 14.4624891275 -109 0 109.5 39.0 -31.2834956141 7.16964906843 -5.13488290263 9.24650944218 -110 1 122.4 80.0 -64.1712730547 14.7069724481 -10.5330931336 18.9671988558 -111 0 108.5 48.7 -39.064262472 8.95286947775 -6.41202044508 11.5462823034 - -Dihedral Coeffs - -1 3 0.6195 1 0.0 -0.2025 2 180.0 0.0175 3 0.0 -2 3 0.0 1 0.0 -0.0405 2 180.0 0.185 3 0.0 -3 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 -4 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 -5 3 -0.1985 1 0.0 1.098 2 180.0 -0.1855 3 0.0 -6 3 0.061 1 0.0 0.0455 2 180.0 0.012 3 0.0 -7 3 0.0 1 0.0 0.0 2 180.0 0.25 3 0.0 -8 3 1.2615 1 0.0 0.4655 2 180.0 -0.205 3 0.0 -9 3 0.0 1 0.0 0.0 2 180.0 0.09 3 0.0 -10 3 0.0 1 0.0 0.0 2 180.0 0.1175 3 0.0 -11 3 0.0 1 0.0 0.0 2 180.0 -0.005 3 0.0 -12 3 0.0 1 0.0 0.0 2 180.0 0.1705 3 0.0 -13 3 0.0 1 0.0 0.0 2 180.0 0.1495 3 0.0 -14 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 -15 3 0.2235 1 0.0 0.8535 2 180.0 -0.671 3 0.0 -16 3 -0.5 1 0.0 1.0 2 180.0 1.0 3 0.0 -17 3 0.0 1 0.0 0.5 2 180.0 0.4 3 0.0 -18 3 0.5 1 0.0 1.125 2 180.0 -1.125 3 0.0 -19 3 0.0 1 0.0 0.5 2 180.0 -0.275 3 0.0 -20 3 0.125 1 0.0 0.08 2 180.0 -0.9025 3 0.0 -21 3 0.0 1 0.0 0.0 2 180.0 0.1705 3 0.0 -22 3 0.0 1 0.0 0.0 2 180.0 0.2375 3 0.0 -23 3 0.0 1 0.0 0.0 2 180.0 0.1495 3 0.0 -24 3 -0.5305 1 0.0 0.066 2 180.0 0.165 3 0.0 -25 3 0.0 1 0.0 0.0 2 180.0 0.33 3 0.0 -26 3 0.397 1 0.0 -0.3195 2 180.0 0.36 3 0.0 -27 3 0.0 1 0.0 0.0 2 180.0 -0.063 3 0.0 -28 3 0.9995 1 0.0 0.0105 2 180.0 0.0 3 0.0 -29 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 -30 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 -31 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 -32 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 -33 3 -0.844 1 0.0 2.1245 2 180.0 0.0 3 0.0 -34 3 0.185 1 0.0 0.297 2 180.0 -0.113 3 0.0 -35 3 0.0 1 0.0 0.0 2 180.0 0.25 3 0.0 -36 3 -0.1285 1 0.0 -0.11 2 180.0 0.0 3 0.0 -37 3 0.0 1 0.0 0.0 2 180.0 0.09 3 0.0 -38 3 0.227 1 0.0 0.04 2 180.0 -0.155 3 0.0 -39 3 -0.2375 1 0.0 0.3875 2 180.0 0.021 3 0.0 -40 3 -0.077 1 0.0 0.022 2 180.0 -0.043 3 0.0 -41 3 0.0 1 0.0 0.0 2 180.0 0.115 3 0.0 -42 3 0.0 1 0.0 0.5 2 180.0 0.4 3 0.0 -43 3 0.9995 1 0.0 0.0105 2 180.0 0.0 3 0.0 -44 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 -45 3 0.387 1 0.0 -0.843 2 180.0 0.0 3 0.0 -46 3 0.0 1 0.0 0.0 2 180.0 0.25 3 0.0 -47 3 0.6715 1 0.0 0.0675 2 180.0 0.0 3 0.0 -48 3 0.0 1 0.0 0.0 2 180.0 0.09 3 0.0 -49 3 0.0 1 0.0 0.0 2 180.0 0.1705 3 0.0 -50 3 0.0 1 0.0 0.0 2 180.0 0.1495 3 0.0 -51 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 -52 3 0.2235 1 0.0 0.8535 2 180.0 -0.671 3 0.0 -53 3 0.428 1 0.0 0.4205 2 180.0 -0.187 3 0.0 -54 3 0.0 1 0.0 0.0 2 180.0 0.0455 3 0.0 -55 3 0.0 1 0.0 0.0 2 180.0 0.1705 3 0.0 -56 3 -0.3155 1 0.0 0.5335 2 180.0 -0.3515 3 0.0 -57 3 -1.142 1 0.0 0.67 2 180.0 0.0 3 0.0 -58 3 -1.6145 1 0.0 0.294 2 180.0 0.0 3 0.0 -59 3 0.0 1 0.0 0.0 2 180.0 0.25 3 0.0 -60 3 -0.2475 1 0.0 0.36 2 180.0 -0.242 3 0.0 -61 3 0.0 1 0.0 0.0 2 180.0 -0.045 3 0.0 -62 3 -0.305 1 0.0 2.106 2 180.0 0.0 3 0.0 -63 3 0.0 1 0.0 2.052 2 180.0 0.0 3 0.0 -64 3 -0.335 1 0.0 2.002 2 180.0 0.0 3 0.0 -65 3 0.275 1 0.0 2.267 2 180.0 -0.275 3 0.0 -66 3 0.0 1 0.0 2.036 2 180.0 0.0 3 0.0 -67 3 0.076 1 0.0 -0.1155 2 180.0 0.189 3 0.0 -68 3 0.0 1 0.0 0.0 2 180.0 0.1705 3 0.0 -69 3 0.076 1 0.0 -0.1155 2 180.0 0.189 3 0.0 -70 3 0.0 1 0.0 0.032 2 180.0 0.3025 3 0.0 -71 3 0.0 1 0.0 0.0 2 180.0 0.187 3 0.0 -72 3 0.0 1 0.0 0.0 2 180.0 -0.055 3 0.0 -73 3 0.0 1 0.0 -0.0405 2 180.0 0.185 3 0.0 -74 3 -0.547 1 0.0 0.3105 2 180.0 0.009 3 0.0 -75 3 -0.269 1 0.0 0.3515 2 180.0 -0.083 3 0.0 -76 3 0.0 1 0.0 0.0 2 180.0 0.1705 3 0.0 -77 3 -0.686 1 0.0 0.116 2 180.0 0.2 3 0.0 -78 3 0.0 1 0.0 0.0 2 180.0 0.1705 3 0.0 -79 3 -0.686 1 0.0 0.116 2 180.0 0.2 3 0.0 -80 3 0.0 1 0.0 0.0 2 180.0 0.133 3 0.0 -81 3 -0.4495 1 0.0 0.539 2 180.0 -0.1705 3 0.0 -82 3 0.574 1 0.0 -0.1445 2 180.0 -0.2785 3 0.0 -83 3 0.0 1 0.0 0.0 2 180.0 0.1705 3 0.0 -84 3 -0.3155 1 0.0 0.5335 2 180.0 -0.3515 3 0.0 -85 3 -0.5 1 0.0 1.0 2 180.0 1.0 3 0.0 -86 3 0.5 1 0.0 1.125 2 180.0 -1.125 3 0.0 -87 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 -88 3 0.0 1 0.0 0.0 2 180.0 -0.063 3 0.0 -89 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 -90 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 -91 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 -92 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 -93 3 0.0 1 0.0 0.0 2 180.0 0.1175 3 0.0 -94 3 0.0 1 0.0 0.0 2 180.0 -0.005 3 0.0 -95 3 -0.5 1 0.0 1.0 2 180.0 1.0 3 0.0 -96 3 0.0 1 0.0 0.5 2 180.0 0.4 3 0.0 -97 3 -2.1285 1 0.0 -0.11 2 180.0 0.0 3 0.0 -98 3 0.0 1 0.0 0.0 2 180.0 0.09 3 0.0 -99 3 0.0 1 0.0 0.05 2 180.0 0.0 3 0.0 -100 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 -101 3 -0.902 1 0.0 1.806 2 180.0 -0.098 3 0.0 -102 3 0.0 1 0.0 0.0 2 180.0 -0.005 3 0.0 -103 3 0.1775 1 0.0 0.739 2 180.0 -0.448 3 0.0 -104 3 -0.5 1 0.0 1.0 2 180.0 1.0 3 0.0 -105 3 -0.5 1 0.0 1.0 2 180.0 1.0 3 0.0 -106 3 0.5 1 0.0 1.125 2 180.0 -1.125 3 0.0 -107 3 0.5 1 0.0 1.125 2 180.0 -1.125 3 0.0 -108 3 -0.12 1 0.0 -1.543 2 180.0 -0.9145 3 0.0 -109 3 0.0 1 0.0 0.0 2 180.0 -0.063 3 0.0 -110 3 1.5445 1 0.0 2.688 2 180.0 -0.9145 3 0.0 -111 3 1.108 1 0.0 0.1075 2 180.0 0.405 3 0.0 -112 3 0.0 1 0.0 0.0 2 180.0 -0.063 3 0.0 -113 3 1.108 1 0.0 0.1075 2 180.0 0.405 3 0.0 -114 3 0.0 1 0.0 0.0 2 180.0 -0.063 3 0.0 -115 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 -116 3 0.0 1 0.0 0.0 2 180.0 -0.063 3 0.0 -117 3 1.108 1 0.0 0.1075 2 180.0 0.405 3 0.0 -118 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 -119 3 -1.059 1 0.0 0.5865 2 180.0 0.0 3 0.0 -120 3 -0.1005 1 0.0 0.3435 2 180.0 0.0 3 0.0 -121 3 0.0 1 0.0 0.0 2 180.0 0.25 3 0.0 -122 3 -0.464 1 0.0 0.5135 2 180.0 0.0 3 0.0 -123 3 0.0 1 0.0 0.0 2 180.0 0.09 3 0.0 -124 3 0.0 1 0.0 0.0 2 180.0 0.1705 3 0.0 -125 3 0.0 1 0.0 0.0 2 180.0 0.1495 3 0.0 -126 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 -127 3 1.1125 1 0.0 -0.626 2 180.0 -0.5335 3 0.0 -128 3 0.076 1 0.0 -0.1155 2 180.0 0.189 3 0.0 -129 3 0.0 1 0.0 0.0 2 180.0 0.1705 3 0.0 -130 3 0.0 1 0.0 0.0 2 180.0 0.1705 3 0.0 -131 3 0.0 1 0.0 0.0 2 180.0 0.1495 3 0.0 -132 3 -0.1005 1 0.0 0.3435 2 180.0 0.0 3 0.0 -133 3 0.0 1 0.0 0.0 2 180.0 0.1705 3 0.0 -134 3 0.0 1 0.0 0.0 2 180.0 0.25 3 0.0 -135 3 0.0 1 0.0 0.0 2 180.0 0.1495 3 0.0 -136 3 0.096 1 0.0 -0.0575 2 180.0 -0.1545 3 0.0 -137 3 -0.832 1 0.0 -0.2655 2 180.0 0.0 3 0.0 -138 3 0.0 1 0.0 0.0 2 180.0 0.1705 3 0.0 -139 3 0.635 1 0.0 -0.5115 2 180.0 -0.3635 3 0.0 -140 3 0.0 1 0.0 0.0 2 180.0 0.137 3 0.0 -141 3 0.0825 1 0.0 0.7 2 180.0 0.0 3 0.0 -142 3 -0.589 1 0.0 0.5275 2 180.0 0.0 3 0.0 -143 3 0.0 1 0.0 0.0 2 180.0 0.09 3 0.0 -144 3 0.0 1 0.0 0.5195 2 180.0 0.0 3 0.0 -145 3 -0.254 1 0.0 -0.1065 2 180.0 -0.1685 3 0.0 -146 3 -1.5315 1 0.0 -0.476 2 180.0 0.199 3 0.0 -147 3 0.0 1 0.0 0.0 2 180.0 0.09 3 0.0 -148 3 0.5455 1 0.0 0.224 2 180.0 0.298 3 0.0 -149 3 0.1405 1 0.0 0.332 2 180.0 -0.4235 3 0.0 -150 3 0.1775 1 0.0 0.739 2 180.0 -0.448 3 0.0 -151 3 -1.059 1 0.0 0.5865 2 180.0 0.0 3 0.0 -152 3 1.1125 1 0.0 -0.626 2 180.0 -0.5335 3 0.0 -153 3 -0.2675 1 0.0 -0.055 2 180.0 -0.0365 3 0.0 -154 3 0.0 1 0.0 0.0 2 180.0 0.187 3 0.0 -155 3 0.491 1 0.0 0.497 2 180.0 0.085 3 0.0 -156 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 -157 3 0.0 1 0.0 0.0 2 180.0 -0.063 3 0.0 -158 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 -159 3 0.0 1 0.0 2.25 2 180.0 0.0 3 0.0 -160 3 0.0 1 0.0 2.0 2 180.0 0.0 3 0.0 -161 3 0.0 1 0.0 2.235 2 180.0 0.0 3 0.0 -162 3 0.0 1 0.0 2.235 2 180.0 0.0 3 0.0 -163 3 0.0 1 0.0 1.0405 2 180.0 0.0 3 0.0 -164 3 0.0 1 0.0 0.0 2 180.0 0.0 3 0.0 -165 3 0.0695 1 0.0 -0.407 2 180.0 0.0 3 0.0 -166 3 0.0 1 0.0 0.0 2 180.0 0.25 3 0.0 -167 3 -0.9105 1 0.0 -1.2185 2 180.0 1.0295 3 0.0 -168 3 0.547 1 0.0 -0.08 2 180.0 0.2515 3 0.0 -169 3 0.0 1 0.0 0.0 2 180.0 0.1495 3 0.0 -170 3 0.0 1 0.0 0.0 2 180.0 0.1495 3 0.0 -171 3 0.0 1 0.0 2.106 2 180.0 0.0 3 0.0 -172 3 0.0 1 0.0 2.052 2 180.0 0.0 3 0.0 -173 3 0.0 1 0.0 2.106 2 180.0 0.0 3 0.0 -174 3 0.0 1 0.0 2.051 2 180.0 0.0 3 0.0 -175 3 0.45 1 0.0 4.0 2 180.0 0.0 3 0.0 -176 3 0.3775 1 0.0 1.5 2 180.0 0.0 3 0.0 -177 3 0.0 1 0.0 3.0 2 180.0 0.0 3 0.0 -178 3 -1.575 1 0.0 1.5 2 180.0 0.0 3 0.0 -179 3 0.0 1 0.0 4.0 2 180.0 0.0 3 0.0 -180 3 0.0 1 0.0 1.5 2 180.0 0.0 3 0.0 -181 3 -1.372 1 0.0 1.5 2 180.0 0.0 3 0.0 -182 3 -0.265 1 0.0 1.5 2 180.0 0.0 3 0.0 -183 3 0.0 1 0.0 1.5 2 180.0 0.0 3 0.0 -184 3 -0.265 1 0.0 1.5 2 180.0 0.0 3 0.0 -185 3 -0.5 1 0.0 1.0 2 180.0 1.0 3 0.0 -186 3 -0.428 1 0.0 0.024 2 180.0 -0.921 3 0.0 -187 3 0.0 1 0.0 4.0 2 180.0 0.0 3 0.0 -188 3 -0.0295 1 0.0 0.95 2 180.0 -0.0225 3 0.0 -189 3 -0.077 1 0.0 0.022 2 180.0 -0.043 3 0.0 - -Improper Coeffs - -1 49.6 -2 54.0 -3 107.9 -4 70.5 -5 41.7 -6 12.9 -7 20.9 -8 14.4 -9 14.4 -10 15.1 -11 41.7 -12 49.6 -13 121.6 -14 118.7 -15 49.6 -16 14.4 -17 14.4 -18 14.4 -19 0.7 -20 3.6 -21 12.9 -22 1.4 -23 14.4 -24 14.4 -25 14.4 -26 14.4 -27 15.1 -28 15.1 -29 12.9 -30 14.4 -31 14.4 -32 14.4 -33 121.6 - -BondAngle Coeffs - -1 4.3 4.3 1.448 1.015 -2 0.0 0.0 0.0 0.0 -3 18.7 18.7 1.509 1.448 -4 11.5 11.5 1.112 1.448 -5 18.7 18.7 1.525 1.448 -6 11.5 11.5 1.509 1.112 -7 18.7 18.7 1.509 1.525 -8 11.5 11.5 1.112 1.525 -9 18.7 18.7 1.2255 1.509 -10 18.7 18.7 1.345 1.509 -11 18.7 18.7 1.345 1.2255 -12 18.7 18.7 1.525 1.525 -13 11.5 11.5 1.525 1.112 -14 11.5 11.5 1.525 1.112 -15 0.0 0.0 0.0 0.0 -16 18.7 18.7 1.525 1.805 -17 11.5 11.5 1.112 1.805 -18 -5.75 -5.75 1.805 1.805 -19 11.5 11.5 1.112 1.805 -20 7.2 7.2 1.345 1.437 -21 4.3 4.3 1.345 1.028 -22 4.3 4.3 1.028 1.437 -23 18.7 18.7 1.437 1.509 -24 11.5 11.5 1.437 1.112 -25 18.7 18.7 1.437 1.525 -26 18.7 18.7 1.509 1.525 -27 11.5 11.5 1.509 1.112 -28 18.7 18.7 1.2255 1.509 -29 18.7 18.7 1.345 1.509 -30 0.0 0.0 0.0 0.0 -31 18.7 18.7 1.437 1.525 -32 18.7 18.7 1.509 1.525 -33 11.5 11.5 1.112 1.525 -34 18.7 18.7 1.525 1.525 -35 18.7 18.7 1.525 1.525 -36 18.7 18.7 1.525 1.499 -37 11.5 11.5 1.112 1.499 -38 18.7 18.7 1.499 1.3887 -39 18.7 18.7 1.3887 1.3887 -40 11.5 11.5 1.3887 1.1 -41 18.7 18.7 1.525 1.525 -42 18.7 18.7 1.525 1.448 -43 11.5 11.5 1.112 1.448 -44 4.3 4.3 1.448 1.015 -45 0.0 0.0 0.0 0.0 -46 18.7 18.7 1.525 1.413 -47 18.7 18.7 1.525 1.413 -48 11.5 11.5 1.112 1.413 -49 12.95 12.95 1.413 0.947 -50 18.7 18.7 1.525 1.525 -51 7.2 7.2 1.437 1.345 -52 4.3 4.3 1.437 1.028 -53 18.7 18.7 1.437 1.509 -54 11.5 11.5 1.437 1.112 -55 11.5 11.5 1.509 1.112 -56 0.0 0.0 0.0 0.0 -57 18.7 18.7 1.509 1.2255 -58 18.7 18.7 1.345 1.509 -59 18.7 18.7 1.525 1.509 -60 11.5 11.5 1.112 1.509 -61 18.7 18.7 1.509 1.2553 -62 18.7 18.7 1.2553 1.2553 -63 18.7 18.7 1.509 1.345 -64 18.7 18.7 1.2255 1.345 -65 7.2 7.2 1.345 1.437 -66 7.2 7.2 1.345 1.437 -67 7.2 7.2 1.437 1.437 -68 18.7 18.7 1.509 1.437 -69 11.5 11.5 1.112 1.437 -70 18.7 18.7 1.437 1.525 -71 18.7 18.7 1.509 1.525 -72 11.5 11.5 1.112 1.525 -73 18.7 18.7 1.525 1.5247 -74 11.5 11.5 1.525 1.112 -75 11.5 11.5 1.112 1.5247 -76 0.0 0.0 0.0 0.0 -77 18.7 18.7 1.5247 1.5247 -78 18.7 18.7 1.437 1.5247 -79 11.5 11.5 1.112 1.437 -80 11.5 11.5 1.112 1.5247 -81 0.0 0.0 0.0 0.0 -82 18.7 18.7 1.525 1.413 -83 11.5 11.5 1.112 1.413 -84 12.95 12.95 1.413 0.947 -85 18.7 18.7 1.525 1.509 -86 18.7 18.7 1.509 1.525 -87 18.7 18.7 1.446 1.525 -88 11.5 11.5 1.446 1.112 -89 7.2 7.2 1.446 1.325 -90 4.3 4.3 1.446 1.028 -91 4.3 4.3 1.028 1.325 -92 18.7 18.7 1.325 1.325 -93 0.0 0.0 0.0 0.0 -94 18.7 18.7 1.3887 1.355 -95 12.95 12.95 1.355 0.947 -96 18.7 18.7 1.525 1.493 -97 11.5 11.5 1.112 1.493 -98 18.7 18.7 1.493 1.373 -99 18.7 18.7 1.493 1.371 -100 18.7 18.7 1.373 1.371 -101 14.4 14.4 1.373 1.352 -102 4.3 4.3 1.03 1.373 -103 4.3 4.3 1.03 1.352 -104 11.5 11.5 1.371 1.081 -105 11.5 11.5 1.373 1.081 -106 18.7 18.7 1.352 1.352 -107 11.5 11.5 1.352 1.081 -108 18.7 18.7 1.437 1.509 -109 11.5 11.5 1.112 1.509 -110 18.7 18.7 1.509 1.2553 -111 0.0 0.0 0.0 0.0 From 30f62cae090902224513e390eb5e7c76d94b4a32 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Tue, 8 Mar 2022 13:41:16 -0700 Subject: [PATCH 078/585] energy/virial tallying for UB bonds --- src/AMOEBA/angle_amoeba.cpp | 5 +-- src/angle.cpp | 88 +++++++++++++++++++++++++++++++++++++ src/angle.h | 1 + 3 files changed, 90 insertions(+), 4 deletions(-) diff --git a/src/AMOEBA/angle_amoeba.cpp b/src/AMOEBA/angle_amoeba.cpp index 5936ff03b4..943024b965 100644 --- a/src/AMOEBA/angle_amoeba.cpp +++ b/src/AMOEBA/angle_amoeba.cpp @@ -574,10 +574,7 @@ void AngleAmoeba::tinker_urey_bradley(int i1, int i2, int type, int eflag) f[i2][2] -= delz*fbond; } - // NOTE: there is no force on i2 for UB - - //if (evflag) ev_tally(i1,i2,i3,nlocal,newton_bond,ebond,f1,f3, - // delx1,dely1,delz1,delx2,dely2,delz2); + if (evflag) ev_tally2(i1,i2,nlocal,newton_bond,ebond,fbond,delx,dely,delz); } /* ---------------------------------------------------------------------- */ diff --git a/src/angle.cpp b/src/angle.cpp index b3b8066a03..4a67d0b202 100644 --- a/src/angle.cpp +++ b/src/angle.cpp @@ -179,6 +179,7 @@ void Angle::ev_setup(int eflag, int vflag, int alloc) /* ---------------------------------------------------------------------- tally energy and virial into global and per-atom accumulators virial = r1F1 + r2F2 + r3F3 = (r1-r2) F1 + (r3-r2) F3 = del1*f1 + del2*f3 + called by standard 3-body angles ------------------------------------------------------------------------- */ void Angle::ev_tally(int i, int j, int k, int nlocal, int newton_bond, @@ -341,6 +342,7 @@ void Angle::ev_tally(int i, int j, int k, int nlocal, int newton_bond, /* ---------------------------------------------------------------------- tally energy and virial into global and per-atom accumulators virial = r1F1 + r2F2 + r3F3 + r4F4 + called by AngleAmoeba for its 4-body angle term ------------------------------------------------------------------------- */ void Angle::ev_tally4(int i, int j, int k, int m, int nlocal, int newton_bond, @@ -437,6 +439,92 @@ void Angle::ev_tally4(int i, int j, int k, int m, int nlocal, int newton_bond, } } + +/* ---------------------------------------------------------------------- + tally energy and virial into global and per-atom accumulators + called by AngleAmoeba for its 2-body Urey-Bradley H-H bond term + identical to Bond:ev_tally() +------------------------------------------------------------------------- */ + +void Angle::ev_tally2(int i, int j, int nlocal, int newton_bond, + double ebond, double fbond, + double delx, double dely, double delz) +{ + double ebondhalf,v[6]; + + if (eflag_either) { + if (eflag_global) { + if (newton_bond) energy += ebond; + else { + ebondhalf = 0.5*ebond; + if (i < nlocal) energy += ebondhalf; + if (j < nlocal) energy += ebondhalf; + } + } + if (eflag_atom) { + ebondhalf = 0.5*ebond; + if (newton_bond || i < nlocal) eatom[i] += ebondhalf; + if (newton_bond || j < nlocal) eatom[j] += ebondhalf; + } + } + + if (vflag_either) { + v[0] = delx*delx*fbond; + v[1] = dely*dely*fbond; + v[2] = delz*delz*fbond; + v[3] = delx*dely*fbond; + v[4] = delx*delz*fbond; + v[5] = dely*delz*fbond; + + if (vflag_global) { + if (newton_bond) { + virial[0] += v[0]; + virial[1] += v[1]; + virial[2] += v[2]; + virial[3] += v[3]; + virial[4] += v[4]; + virial[5] += v[5]; + } else { + if (i < nlocal) { + virial[0] += 0.5*v[0]; + virial[1] += 0.5*v[1]; + virial[2] += 0.5*v[2]; + virial[3] += 0.5*v[3]; + virial[4] += 0.5*v[4]; + virial[5] += 0.5*v[5]; + } + if (j < nlocal) { + virial[0] += 0.5*v[0]; + virial[1] += 0.5*v[1]; + virial[2] += 0.5*v[2]; + virial[3] += 0.5*v[3]; + virial[4] += 0.5*v[4]; + virial[5] += 0.5*v[5]; + } + } + } + + if (vflag_atom) { + if (newton_bond || i < nlocal) { + vatom[i][0] += 0.5*v[0]; + vatom[i][1] += 0.5*v[1]; + vatom[i][2] += 0.5*v[2]; + vatom[i][3] += 0.5*v[3]; + vatom[i][4] += 0.5*v[4]; + vatom[i][5] += 0.5*v[5]; + } + if (newton_bond || j < nlocal) { + vatom[j][0] += 0.5*v[0]; + vatom[j][1] += 0.5*v[1]; + vatom[j][2] += 0.5*v[2]; + vatom[j][3] += 0.5*v[3]; + vatom[j][4] += 0.5*v[4]; + vatom[j][5] += 0.5*v[5]; + } + } + } +} + /* ---------------------------------------------------------------------- */ double Angle::memory_usage() diff --git a/src/angle.h b/src/angle.h index 434986e042..001ee2d2bc 100644 --- a/src/angle.h +++ b/src/angle.h @@ -78,6 +78,7 @@ class Angle : protected Pointers { void ev_tally(int, int, int, int, int, double, double *, double *, double, double, double, double, double, double); void ev_tally4(int, int, int, int, int, int, double, double *, double *, double *, double *); + void ev_tally2(int, int, int, int, double, double, double, double, double); }; } // namespace LAMMPS_NS From 095ddbd370e62d25e21f24fc8c464f7c4a91ce92 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Tue, 8 Mar 2022 13:49:47 -0700 Subject: [PATCH 079/585] debugging --- src/AMOEBA/angle_amoeba.cpp | 25 +++++++++++++++++-------- 1 file changed, 17 insertions(+), 8 deletions(-) diff --git a/src/AMOEBA/angle_amoeba.cpp b/src/AMOEBA/angle_amoeba.cpp index 943024b965..9e29f1eee8 100644 --- a/src/AMOEBA/angle_amoeba.cpp +++ b/src/AMOEBA/angle_amoeba.cpp @@ -103,6 +103,8 @@ void AngleAmoeba::compute(int eflag, int vflag) ev_init(eflag,vflag); + int ubn = 0; + for (n = 0; n < nanglelist; n++) { i1 = anglelist[n][0]; i2 = anglelist[n][1]; @@ -128,8 +130,13 @@ void AngleAmoeba::compute(int eflag, int vflag) uflag = ubflag[type]; - if (uflag) tinker_urey_bradley(i1,i3,type,eflag); + if (uflag) { + ubn++; + tinker_urey_bradley(i1,i3,type,eflag); + } } + + printf("UB N %d\n",ubn); } /* ---------------------------------------------------------------------- */ @@ -655,20 +662,22 @@ void AngleAmoeba::coeff(int narg, char **arg) } } else { - if (narg != 8) error->all(FLERR,"Incorrect args for angle coefficients"); + if (narg != 9) error->all(FLERR,"Incorrect args for angle coefficients"); int pflag_one = utils::inumeric(FLERR,arg[1],false,lmp); - double theta0_one = utils::numeric(FLERR,arg[2],false,lmp); - double k2_one = utils::numeric(FLERR,arg[3],false,lmp); - double k3_one = utils::numeric(FLERR,arg[4],false,lmp); - double k4_one = utils::numeric(FLERR,arg[5],false,lmp); - double k5_one = utils::numeric(FLERR,arg[6],false,lmp); - double k6_one = utils::numeric(FLERR,arg[7],false,lmp); + int ubflag_one = utils::inumeric(FLERR,arg[2],false,lmp); + double theta0_one = utils::numeric(FLERR,arg[3],false,lmp); + double k2_one = utils::numeric(FLERR,arg[4],false,lmp); + double k3_one = utils::numeric(FLERR,arg[5],false,lmp); + double k4_one = utils::numeric(FLERR,arg[6],false,lmp); + double k5_one = utils::numeric(FLERR,arg[7],false,lmp); + double k6_one = utils::numeric(FLERR,arg[8],false,lmp); // convert theta0 from degrees to radians for (int i = ilo; i <= ihi; i++) { pflag[i] = pflag_one; + ubflag[i] = ubflag_one; theta0[i] = theta0_one/180.0 * MY_PI; k2[i] = k2_one; k3[i] = k3_one; From 844ea0ab8e96b317ce86f5c9e57d99b4983e27ef Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Tue, 8 Mar 2022 15:37:16 -0700 Subject: [PATCH 080/585] UB testing --- examples/amoeba/data.ubiquitin | 9740 ++++++++++++++++++++++++++++++++ src/AMOEBA/angle_amoeba.cpp | 11 +- src/AMOEBA/angle_amoeba.h | 2 +- src/read_data.cpp | 8 + tools/tinker/data.py | 40 +- 5 files changed, 9787 insertions(+), 14 deletions(-) diff --git a/examples/amoeba/data.ubiquitin b/examples/amoeba/data.ubiquitin index 319aadf8ec..a7b8684618 100644 --- a/examples/amoeba/data.ubiquitin +++ b/examples/amoeba/data.ubiquitin @@ -26345,3 +26345,9743 @@ UreyBradley Coeffs 109 0.0 0.0 110 0.0 0.0 111 -7.6 1.5537 + +Tinker Types + +1 234 +2 8 +3 9 +4 11 +5 235 +6 235 +7 235 +8 12 +9 178 +10 180 +11 182 +12 183 +13 179 +14 179 +15 181 +16 181 +17 184 +18 184 +19 184 +20 7 +21 8 +22 9 +23 11 +24 10 +25 12 +26 170 +27 172 +28 174 +29 175 +30 176 +31 171 +32 171 +33 173 +34 173 +35 177 +36 177 +37 7 +38 8 +39 9 +40 11 +41 10 +42 12 +43 25 +44 29 +45 27 +46 31 +47 26 +48 30 +49 30 +50 28 +51 28 +52 28 +53 32 +54 32 +55 32 +56 7 +57 8 +58 9 +59 11 +60 10 +61 12 +62 64 +63 66 +64 67 +65 67 +66 69 +67 69 +68 71 +69 65 +70 65 +71 68 +72 68 +73 70 +74 70 +75 72 +76 7 +77 8 +78 9 +79 11 +80 10 +81 12 +82 15 +83 17 +84 17 +85 16 +86 18 +87 18 +88 18 +89 18 +90 18 +91 18 +92 7 +93 8 +94 9 +95 11 +96 10 +97 12 +98 185 +99 187 +100 189 +101 191 +102 193 +103 186 +104 186 +105 188 +106 188 +107 190 +108 190 +109 192 +110 192 +111 194 +112 194 +113 194 +114 7 +115 33 +116 9 +117 11 +118 10 +119 12 +120 38 +121 42 +122 40 +123 39 +124 43 +125 41 +126 41 +127 41 +128 7 +129 8 +130 9 +131 11 +132 10 +133 12 +134 19 +135 21 +136 23 +137 23 +138 20 +139 20 +140 22 +141 24 +142 24 +143 24 +144 24 +145 24 +146 24 +147 7 +148 33 +149 9 +150 11 +151 10 +152 12 +153 38 +154 42 +155 40 +156 39 +157 43 +158 41 +159 41 +160 41 +161 1 +162 2 +163 3 +164 5 +165 4 +166 6 +167 6 +168 7 +169 8 +170 9 +171 11 +172 10 +173 12 +174 185 +175 187 +176 189 +177 191 +178 193 +179 186 +180 186 +181 188 +182 188 +183 190 +184 190 +185 192 +186 192 +187 194 +188 194 +189 194 +190 7 +191 33 +192 9 +193 11 +194 10 +195 12 +196 38 +197 42 +198 40 +199 39 +200 43 +201 41 +202 41 +203 41 +204 7 +205 8 +206 9 +207 11 +208 10 +209 12 +210 25 +211 29 +212 27 +213 31 +214 26 +215 30 +216 30 +217 28 +218 28 +219 28 +220 32 +221 32 +222 32 +223 7 +224 33 +225 9 +226 11 +227 10 +228 12 +229 38 +230 42 +231 40 +232 39 +233 43 +234 41 +235 41 +236 41 +237 7 +238 8 +239 9 +240 11 +241 10 +242 12 +243 19 +244 21 +245 23 +246 23 +247 20 +248 20 +249 22 +250 24 +251 24 +252 24 +253 24 +254 24 +255 24 +256 7 +257 8 +258 9 +259 11 +260 10 +261 12 +262 156 +263 158 +264 160 +265 161 +266 161 +267 157 +268 157 +269 159 +270 159 +271 7 +272 8 +273 9 +274 11 +275 10 +276 12 +277 15 +278 17 +279 17 +280 16 +281 18 +282 18 +283 18 +284 18 +285 18 +286 18 +287 7 +288 8 +289 9 +290 11 +291 10 +292 12 +293 156 +294 158 +295 160 +296 161 +297 161 +298 157 +299 157 +300 159 +301 159 +302 53 +303 54 +304 55 +305 56 +306 57 +307 58 +308 60 +309 62 +310 59 +311 59 +312 61 +313 61 +314 63 +315 63 +316 7 +317 33 +318 9 +319 11 +320 10 +321 12 +322 34 +323 36 +324 35 +325 35 +326 37 +327 7 +328 8 +329 9 +330 11 +331 10 +332 12 +333 140 +334 142 +335 143 +336 143 +337 141 +338 141 +339 7 +340 33 +341 9 +342 11 +343 10 +344 12 +345 38 +346 42 +347 40 +348 39 +349 43 +350 41 +351 41 +352 41 +353 7 +354 8 +355 9 +356 11 +357 10 +358 12 +359 25 +360 29 +361 27 +362 31 +363 26 +364 30 +365 30 +366 28 +367 28 +368 28 +369 32 +370 32 +371 32 +372 7 +373 8 +374 9 +375 11 +376 10 +377 12 +378 156 +379 158 +380 160 +381 161 +382 161 +383 157 +384 157 +385 159 +386 159 +387 7 +388 8 +389 9 +390 11 +391 10 +392 12 +393 150 +394 152 +395 153 +396 154 +397 151 +398 151 +399 155 +400 155 +401 7 +402 8 +403 9 +404 11 +405 10 +406 12 +407 15 +408 17 +409 17 +410 16 +411 18 +412 18 +413 18 +414 18 +415 18 +416 18 +417 7 +418 8 +419 9 +420 11 +421 10 +422 12 +423 185 +424 187 +425 189 +426 191 +427 193 +428 186 +429 186 +430 188 +431 188 +432 190 +433 190 +434 192 +435 192 +436 194 +437 194 +438 194 +439 7 +440 8 +441 9 +442 11 +443 10 +444 12 +445 13 +446 14 +447 14 +448 14 +449 7 +450 8 +451 9 +452 11 +453 10 +454 12 +455 185 +456 187 +457 189 +458 191 +459 193 +460 186 +461 186 +462 188 +463 188 +464 190 +465 190 +466 192 +467 192 +468 194 +469 194 +470 194 +471 7 +472 8 +473 9 +474 11 +475 10 +476 12 +477 25 +478 29 +479 27 +480 31 +481 26 +482 30 +483 30 +484 28 +485 28 +486 28 +487 32 +488 32 +489 32 +490 7 +491 8 +492 9 +493 11 +494 10 +495 12 +496 170 +497 172 +498 174 +499 175 +500 176 +501 171 +502 171 +503 173 +504 173 +505 177 +506 177 +507 7 +508 8 +509 9 +510 11 +511 10 +512 12 +513 140 +514 142 +515 143 +516 143 +517 141 +518 141 +519 7 +520 8 +521 9 +522 11 +523 10 +524 12 +525 185 +526 187 +527 189 +528 191 +529 193 +530 186 +531 186 +532 188 +533 188 +534 190 +535 190 +536 192 +537 192 +538 194 +539 194 +540 194 +541 7 +542 8 +543 9 +544 11 +545 10 +546 12 +547 156 +548 158 +549 160 +550 161 +551 161 +552 157 +553 157 +554 159 +555 159 +556 1 +557 2 +558 3 +559 5 +560 4 +561 6 +562 6 +563 7 +564 8 +565 9 +566 11 +567 10 +568 12 +569 25 +570 29 +571 27 +572 31 +573 26 +574 30 +575 30 +576 28 +577 28 +578 28 +579 32 +580 32 +581 32 +582 53 +583 54 +584 55 +585 56 +586 57 +587 58 +588 60 +589 62 +590 59 +591 59 +592 61 +593 61 +594 63 +595 63 +596 53 +597 54 +598 55 +599 56 +600 57 +601 58 +602 60 +603 62 +604 59 +605 59 +606 61 +607 61 +608 63 +609 63 +610 7 +611 8 +612 9 +613 11 +614 10 +615 12 +616 140 +617 142 +618 143 +619 143 +620 141 +621 141 +622 7 +623 8 +624 9 +625 11 +626 10 +627 12 +628 170 +629 172 +630 174 +631 175 +632 176 +633 171 +634 171 +635 173 +636 173 +637 177 +638 177 +639 7 +640 8 +641 9 +642 11 +643 10 +644 12 +645 170 +646 172 +647 174 +648 175 +649 176 +650 171 +651 171 +652 173 +653 173 +654 177 +655 177 +656 7 +657 8 +658 9 +659 11 +660 10 +661 12 +662 205 +663 207 +664 209 +665 211 +666 213 +667 214 +668 214 +669 206 +670 206 +671 208 +672 208 +673 210 +674 210 +675 212 +676 215 +677 215 +678 215 +679 215 +680 7 +681 8 +682 9 +683 11 +684 10 +685 12 +686 19 +687 21 +688 23 +689 23 +690 20 +691 20 +692 22 +693 24 +694 24 +695 24 +696 24 +697 24 +698 24 +699 7 +700 8 +701 9 +702 11 +703 10 +704 12 +705 25 +706 29 +707 27 +708 31 +709 26 +710 30 +711 30 +712 28 +713 28 +714 28 +715 32 +716 32 +717 32 +718 7 +719 8 +720 9 +721 11 +722 10 +723 12 +724 64 +725 66 +726 67 +727 67 +728 69 +729 69 +730 71 +731 65 +732 65 +733 68 +734 68 +735 70 +736 70 +737 72 +738 7 +739 8 +740 9 +741 11 +742 10 +743 12 +744 13 +745 14 +746 14 +747 14 +748 1 +749 2 +750 3 +751 5 +752 4 +753 6 +754 6 +755 7 +756 8 +757 9 +758 11 +759 10 +760 12 +761 185 +762 187 +763 189 +764 191 +765 193 +766 186 +767 186 +768 188 +769 188 +770 190 +771 190 +772 192 +773 192 +774 194 +775 194 +776 194 +777 7 +778 8 +779 9 +780 11 +781 10 +782 12 +783 170 +784 172 +785 174 +786 175 +787 176 +788 171 +789 171 +790 173 +791 173 +792 177 +793 177 +794 7 +795 8 +796 9 +797 11 +798 10 +799 12 +800 19 +801 21 +802 23 +803 23 +804 20 +805 20 +806 22 +807 24 +808 24 +809 24 +810 24 +811 24 +812 24 +813 7 +814 8 +815 9 +816 11 +817 10 +818 12 +819 156 +820 158 +821 160 +822 161 +823 161 +824 157 +825 157 +826 159 +827 159 +828 7 +829 8 +830 9 +831 11 +832 10 +833 12 +834 140 +835 142 +836 143 +837 143 +838 141 +839 141 +840 1 +841 2 +842 3 +843 5 +844 4 +845 6 +846 6 +847 7 +848 8 +849 9 +850 11 +851 10 +852 12 +853 205 +854 207 +855 209 +856 211 +857 213 +858 214 +859 214 +860 206 +861 206 +862 208 +863 208 +864 210 +865 210 +866 212 +867 215 +868 215 +869 215 +870 215 +871 7 +872 33 +873 9 +874 11 +875 10 +876 12 +877 38 +878 42 +879 40 +880 39 +881 43 +882 41 +883 41 +884 41 +885 7 +886 8 +887 9 +888 11 +889 10 +890 12 +891 19 +892 21 +893 23 +894 23 +895 20 +896 20 +897 22 +898 24 +899 24 +900 24 +901 24 +902 24 +903 24 +904 7 +905 33 +906 9 +907 11 +908 10 +909 12 +910 34 +911 36 +912 35 +913 35 +914 37 +915 7 +916 8 +917 9 +918 11 +919 10 +920 12 +921 140 +922 142 +923 143 +924 143 +925 141 +926 141 +927 7 +928 8 +929 9 +930 11 +931 10 +932 12 +933 73 +934 75 +935 76 +936 76 +937 78 +938 78 +939 80 +940 81 +941 74 +942 74 +943 77 +944 77 +945 79 +946 79 +947 82 +948 7 +949 8 +950 9 +951 11 +952 10 +953 12 +954 150 +955 152 +956 153 +957 154 +958 151 +959 151 +960 155 +961 155 +962 7 +963 8 +964 9 +965 11 +966 10 +967 12 +968 25 +969 29 +970 27 +971 31 +972 26 +973 30 +974 30 +975 28 +976 28 +977 28 +978 32 +979 32 +980 32 +981 7 +982 8 +983 9 +984 11 +985 10 +986 12 +987 170 +988 172 +989 174 +990 175 +991 176 +992 171 +993 171 +994 173 +995 173 +996 177 +997 177 +998 7 +999 8 +1000 9 +1001 11 +1002 10 +1003 12 +1004 185 +1005 187 +1006 189 +1007 191 +1008 193 +1009 186 +1010 186 +1011 188 +1012 188 +1013 190 +1014 190 +1015 192 +1016 192 +1017 194 +1018 194 +1019 194 +1020 7 +1021 8 +1022 9 +1023 11 +1024 10 +1025 12 +1026 156 +1027 158 +1028 160 +1029 161 +1030 161 +1031 157 +1032 157 +1033 159 +1034 159 +1035 7 +1036 33 +1037 9 +1038 11 +1039 10 +1040 12 +1041 34 +1042 36 +1043 35 +1044 35 +1045 37 +1046 7 +1047 33 +1048 9 +1049 11 +1050 10 +1051 12 +1052 38 +1053 42 +1054 40 +1055 39 +1056 43 +1057 41 +1058 41 +1059 41 +1060 7 +1061 8 +1062 9 +1063 11 +1064 10 +1065 12 +1066 19 +1067 21 +1068 23 +1069 23 +1070 20 +1071 20 +1072 22 +1073 24 +1074 24 +1075 24 +1076 24 +1077 24 +1078 24 +1079 7 +1080 8 +1081 9 +1082 11 +1083 10 +1084 12 +1085 109 +1086 111 +1087 112 +1088 114 +1089 116 +1090 118 +1091 110 +1092 110 +1093 113 +1094 115 +1095 117 +1096 119 +1097 7 +1098 8 +1099 9 +1100 11 +1101 10 +1102 12 +1103 19 +1104 21 +1105 23 +1106 23 +1107 20 +1108 20 +1109 22 +1110 24 +1111 24 +1112 24 +1113 24 +1114 24 +1115 24 +1116 7 +1117 8 +1118 9 +1119 11 +1120 10 +1121 12 +1122 15 +1123 17 +1124 17 +1125 16 +1126 18 +1127 18 +1128 18 +1129 18 +1130 18 +1131 18 +1132 7 +1133 8 +1134 9 +1135 11 +1136 10 +1137 12 +1138 19 +1139 21 +1140 23 +1141 23 +1142 20 +1143 20 +1144 22 +1145 24 +1146 24 +1147 24 +1148 24 +1149 24 +1150 24 +1151 7 +1152 8 +1153 9 +1154 11 +1155 10 +1156 12 +1157 205 +1158 207 +1159 209 +1160 211 +1161 213 +1162 214 +1163 214 +1164 206 +1165 206 +1166 208 +1167 208 +1168 210 +1169 210 +1170 212 +1171 215 +1172 215 +1173 215 +1174 215 +1175 7 +1176 8 +1177 9 +1178 11 +1179 10 +1180 12 +1181 19 +1182 21 +1183 23 +1184 23 +1185 20 +1186 20 +1187 22 +1188 24 +1189 24 +1190 24 +1191 24 +1192 24 +1193 24 +1194 7 +1195 8 +1196 9 +1197 11 +1198 10 +1199 12 +1200 205 +1201 207 +1202 209 +1203 211 +1204 213 +1205 214 +1206 214 +1207 206 +1208 206 +1209 208 +1210 208 +1211 210 +1212 210 +1213 212 +1214 215 +1215 215 +1216 215 +1217 215 +1218 1 +1219 2 +1220 3 +1221 5 +1222 4 +1223 6 +1224 6 +1225 1 +1226 2 +1227 238 +1228 239 +1229 4 +1230 6 +1231 6 +1232 239 +1233 402 +1234 403 +1235 403 +1236 402 +1237 403 +1238 403 +1239 402 +1240 403 +1241 403 +1242 402 +1243 403 +1244 403 +1245 402 +1246 403 +1247 403 +1248 402 +1249 403 +1250 403 +1251 402 +1252 403 +1253 403 +1254 402 +1255 403 +1256 403 +1257 402 +1258 403 +1259 403 +1260 402 +1261 403 +1262 403 +1263 402 +1264 403 +1265 403 +1266 402 +1267 403 +1268 403 +1269 402 +1270 403 +1271 403 +1272 402 +1273 403 +1274 403 +1275 402 +1276 403 +1277 403 +1278 402 +1279 403 +1280 403 +1281 402 +1282 403 +1283 403 +1284 402 +1285 403 +1286 403 +1287 402 +1288 403 +1289 403 +1290 402 +1291 403 +1292 403 +1293 402 +1294 403 +1295 403 +1296 402 +1297 403 +1298 403 +1299 402 +1300 403 +1301 403 +1302 402 +1303 403 +1304 403 +1305 402 +1306 403 +1307 403 +1308 402 +1309 403 +1310 403 +1311 402 +1312 403 +1313 403 +1314 402 +1315 403 +1316 403 +1317 402 +1318 403 +1319 403 +1320 402 +1321 403 +1322 403 +1323 402 +1324 403 +1325 403 +1326 402 +1327 403 +1328 403 +1329 402 +1330 403 +1331 403 +1332 402 +1333 403 +1334 403 +1335 402 +1336 403 +1337 403 +1338 402 +1339 403 +1340 403 +1341 402 +1342 403 +1343 403 +1344 402 +1345 403 +1346 403 +1347 402 +1348 403 +1349 403 +1350 402 +1351 403 +1352 403 +1353 402 +1354 403 +1355 403 +1356 402 +1357 403 +1358 403 +1359 402 +1360 403 +1361 403 +1362 402 +1363 403 +1364 403 +1365 402 +1366 403 +1367 403 +1368 402 +1369 403 +1370 403 +1371 402 +1372 403 +1373 403 +1374 402 +1375 403 +1376 403 +1377 402 +1378 403 +1379 403 +1380 402 +1381 403 +1382 403 +1383 402 +1384 403 +1385 403 +1386 402 +1387 403 +1388 403 +1389 402 +1390 403 +1391 403 +1392 402 +1393 403 +1394 403 +1395 402 +1396 403 +1397 403 +1398 402 +1399 403 +1400 403 +1401 402 +1402 403 +1403 403 +1404 402 +1405 403 +1406 403 +1407 402 +1408 403 +1409 403 +1410 402 +1411 403 +1412 403 +1413 402 +1414 403 +1415 403 +1416 402 +1417 403 +1418 403 +1419 402 +1420 403 +1421 403 +1422 402 +1423 403 +1424 403 +1425 402 +1426 403 +1427 403 +1428 402 +1429 403 +1430 403 +1431 402 +1432 403 +1433 403 +1434 402 +1435 403 +1436 403 +1437 402 +1438 403 +1439 403 +1440 402 +1441 403 +1442 403 +1443 402 +1444 403 +1445 403 +1446 402 +1447 403 +1448 403 +1449 402 +1450 403 +1451 403 +1452 402 +1453 403 +1454 403 +1455 402 +1456 403 +1457 403 +1458 402 +1459 403 +1460 403 +1461 402 +1462 403 +1463 403 +1464 402 +1465 403 +1466 403 +1467 402 +1468 403 +1469 403 +1470 402 +1471 403 +1472 403 +1473 402 +1474 403 +1475 403 +1476 402 +1477 403 +1478 403 +1479 402 +1480 403 +1481 403 +1482 402 +1483 403 +1484 403 +1485 402 +1486 403 +1487 403 +1488 402 +1489 403 +1490 403 +1491 402 +1492 403 +1493 403 +1494 402 +1495 403 +1496 403 +1497 402 +1498 403 +1499 403 +1500 402 +1501 403 +1502 403 +1503 402 +1504 403 +1505 403 +1506 402 +1507 403 +1508 403 +1509 402 +1510 403 +1511 403 +1512 402 +1513 403 +1514 403 +1515 402 +1516 403 +1517 403 +1518 402 +1519 403 +1520 403 +1521 402 +1522 403 +1523 403 +1524 402 +1525 403 +1526 403 +1527 402 +1528 403 +1529 403 +1530 402 +1531 403 +1532 403 +1533 402 +1534 403 +1535 403 +1536 402 +1537 403 +1538 403 +1539 402 +1540 403 +1541 403 +1542 402 +1543 403 +1544 403 +1545 402 +1546 403 +1547 403 +1548 402 +1549 403 +1550 403 +1551 402 +1552 403 +1553 403 +1554 402 +1555 403 +1556 403 +1557 402 +1558 403 +1559 403 +1560 402 +1561 403 +1562 403 +1563 402 +1564 403 +1565 403 +1566 402 +1567 403 +1568 403 +1569 402 +1570 403 +1571 403 +1572 402 +1573 403 +1574 403 +1575 402 +1576 403 +1577 403 +1578 402 +1579 403 +1580 403 +1581 402 +1582 403 +1583 403 +1584 402 +1585 403 +1586 403 +1587 402 +1588 403 +1589 403 +1590 402 +1591 403 +1592 403 +1593 402 +1594 403 +1595 403 +1596 402 +1597 403 +1598 403 +1599 402 +1600 403 +1601 403 +1602 402 +1603 403 +1604 403 +1605 402 +1606 403 +1607 403 +1608 402 +1609 403 +1610 403 +1611 402 +1612 403 +1613 403 +1614 402 +1615 403 +1616 403 +1617 402 +1618 403 +1619 403 +1620 402 +1621 403 +1622 403 +1623 402 +1624 403 +1625 403 +1626 402 +1627 403 +1628 403 +1629 402 +1630 403 +1631 403 +1632 402 +1633 403 +1634 403 +1635 402 +1636 403 +1637 403 +1638 402 +1639 403 +1640 403 +1641 402 +1642 403 +1643 403 +1644 402 +1645 403 +1646 403 +1647 402 +1648 403 +1649 403 +1650 402 +1651 403 +1652 403 +1653 402 +1654 403 +1655 403 +1656 402 +1657 403 +1658 403 +1659 402 +1660 403 +1661 403 +1662 402 +1663 403 +1664 403 +1665 402 +1666 403 +1667 403 +1668 402 +1669 403 +1670 403 +1671 402 +1672 403 +1673 403 +1674 402 +1675 403 +1676 403 +1677 402 +1678 403 +1679 403 +1680 402 +1681 403 +1682 403 +1683 402 +1684 403 +1685 403 +1686 402 +1687 403 +1688 403 +1689 402 +1690 403 +1691 403 +1692 402 +1693 403 +1694 403 +1695 402 +1696 403 +1697 403 +1698 402 +1699 403 +1700 403 +1701 402 +1702 403 +1703 403 +1704 402 +1705 403 +1706 403 +1707 402 +1708 403 +1709 403 +1710 402 +1711 403 +1712 403 +1713 402 +1714 403 +1715 403 +1716 402 +1717 403 +1718 403 +1719 402 +1720 403 +1721 403 +1722 402 +1723 403 +1724 403 +1725 402 +1726 403 +1727 403 +1728 402 +1729 403 +1730 403 +1731 402 +1732 403 +1733 403 +1734 402 +1735 403 +1736 403 +1737 402 +1738 403 +1739 403 +1740 402 +1741 403 +1742 403 +1743 402 +1744 403 +1745 403 +1746 402 +1747 403 +1748 403 +1749 402 +1750 403 +1751 403 +1752 402 +1753 403 +1754 403 +1755 402 +1756 403 +1757 403 +1758 402 +1759 403 +1760 403 +1761 402 +1762 403 +1763 403 +1764 402 +1765 403 +1766 403 +1767 402 +1768 403 +1769 403 +1770 402 +1771 403 +1772 403 +1773 402 +1774 403 +1775 403 +1776 402 +1777 403 +1778 403 +1779 402 +1780 403 +1781 403 +1782 402 +1783 403 +1784 403 +1785 402 +1786 403 +1787 403 +1788 402 +1789 403 +1790 403 +1791 402 +1792 403 +1793 403 +1794 402 +1795 403 +1796 403 +1797 402 +1798 403 +1799 403 +1800 402 +1801 403 +1802 403 +1803 402 +1804 403 +1805 403 +1806 402 +1807 403 +1808 403 +1809 402 +1810 403 +1811 403 +1812 402 +1813 403 +1814 403 +1815 402 +1816 403 +1817 403 +1818 402 +1819 403 +1820 403 +1821 402 +1822 403 +1823 403 +1824 402 +1825 403 +1826 403 +1827 402 +1828 403 +1829 403 +1830 402 +1831 403 +1832 403 +1833 402 +1834 403 +1835 403 +1836 402 +1837 403 +1838 403 +1839 402 +1840 403 +1841 403 +1842 402 +1843 403 +1844 403 +1845 402 +1846 403 +1847 403 +1848 402 +1849 403 +1850 403 +1851 402 +1852 403 +1853 403 +1854 402 +1855 403 +1856 403 +1857 402 +1858 403 +1859 403 +1860 402 +1861 403 +1862 403 +1863 402 +1864 403 +1865 403 +1866 402 +1867 403 +1868 403 +1869 402 +1870 403 +1871 403 +1872 402 +1873 403 +1874 403 +1875 402 +1876 403 +1877 403 +1878 402 +1879 403 +1880 403 +1881 402 +1882 403 +1883 403 +1884 402 +1885 403 +1886 403 +1887 402 +1888 403 +1889 403 +1890 402 +1891 403 +1892 403 +1893 402 +1894 403 +1895 403 +1896 402 +1897 403 +1898 403 +1899 402 +1900 403 +1901 403 +1902 402 +1903 403 +1904 403 +1905 402 +1906 403 +1907 403 +1908 402 +1909 403 +1910 403 +1911 402 +1912 403 +1913 403 +1914 402 +1915 403 +1916 403 +1917 402 +1918 403 +1919 403 +1920 402 +1921 403 +1922 403 +1923 402 +1924 403 +1925 403 +1926 402 +1927 403 +1928 403 +1929 402 +1930 403 +1931 403 +1932 402 +1933 403 +1934 403 +1935 402 +1936 403 +1937 403 +1938 402 +1939 403 +1940 403 +1941 402 +1942 403 +1943 403 +1944 402 +1945 403 +1946 403 +1947 402 +1948 403 +1949 403 +1950 402 +1951 403 +1952 403 +1953 402 +1954 403 +1955 403 +1956 402 +1957 403 +1958 403 +1959 402 +1960 403 +1961 403 +1962 402 +1963 403 +1964 403 +1965 402 +1966 403 +1967 403 +1968 402 +1969 403 +1970 403 +1971 402 +1972 403 +1973 403 +1974 402 +1975 403 +1976 403 +1977 402 +1978 403 +1979 403 +1980 402 +1981 403 +1982 403 +1983 402 +1984 403 +1985 403 +1986 402 +1987 403 +1988 403 +1989 402 +1990 403 +1991 403 +1992 402 +1993 403 +1994 403 +1995 402 +1996 403 +1997 403 +1998 402 +1999 403 +2000 403 +2001 402 +2002 403 +2003 403 +2004 402 +2005 403 +2006 403 +2007 402 +2008 403 +2009 403 +2010 402 +2011 403 +2012 403 +2013 402 +2014 403 +2015 403 +2016 402 +2017 403 +2018 403 +2019 402 +2020 403 +2021 403 +2022 402 +2023 403 +2024 403 +2025 402 +2026 403 +2027 403 +2028 402 +2029 403 +2030 403 +2031 402 +2032 403 +2033 403 +2034 402 +2035 403 +2036 403 +2037 402 +2038 403 +2039 403 +2040 402 +2041 403 +2042 403 +2043 402 +2044 403 +2045 403 +2046 402 +2047 403 +2048 403 +2049 402 +2050 403 +2051 403 +2052 402 +2053 403 +2054 403 +2055 402 +2056 403 +2057 403 +2058 402 +2059 403 +2060 403 +2061 402 +2062 403 +2063 403 +2064 402 +2065 403 +2066 403 +2067 402 +2068 403 +2069 403 +2070 402 +2071 403 +2072 403 +2073 402 +2074 403 +2075 403 +2076 402 +2077 403 +2078 403 +2079 402 +2080 403 +2081 403 +2082 402 +2083 403 +2084 403 +2085 402 +2086 403 +2087 403 +2088 402 +2089 403 +2090 403 +2091 402 +2092 403 +2093 403 +2094 402 +2095 403 +2096 403 +2097 402 +2098 403 +2099 403 +2100 402 +2101 403 +2102 403 +2103 402 +2104 403 +2105 403 +2106 402 +2107 403 +2108 403 +2109 402 +2110 403 +2111 403 +2112 402 +2113 403 +2114 403 +2115 402 +2116 403 +2117 403 +2118 402 +2119 403 +2120 403 +2121 402 +2122 403 +2123 403 +2124 402 +2125 403 +2126 403 +2127 402 +2128 403 +2129 403 +2130 402 +2131 403 +2132 403 +2133 402 +2134 403 +2135 403 +2136 402 +2137 403 +2138 403 +2139 402 +2140 403 +2141 403 +2142 402 +2143 403 +2144 403 +2145 402 +2146 403 +2147 403 +2148 402 +2149 403 +2150 403 +2151 402 +2152 403 +2153 403 +2154 402 +2155 403 +2156 403 +2157 402 +2158 403 +2159 403 +2160 402 +2161 403 +2162 403 +2163 402 +2164 403 +2165 403 +2166 402 +2167 403 +2168 403 +2169 402 +2170 403 +2171 403 +2172 402 +2173 403 +2174 403 +2175 402 +2176 403 +2177 403 +2178 402 +2179 403 +2180 403 +2181 402 +2182 403 +2183 403 +2184 402 +2185 403 +2186 403 +2187 402 +2188 403 +2189 403 +2190 402 +2191 403 +2192 403 +2193 402 +2194 403 +2195 403 +2196 402 +2197 403 +2198 403 +2199 402 +2200 403 +2201 403 +2202 402 +2203 403 +2204 403 +2205 402 +2206 403 +2207 403 +2208 402 +2209 403 +2210 403 +2211 402 +2212 403 +2213 403 +2214 402 +2215 403 +2216 403 +2217 402 +2218 403 +2219 403 +2220 402 +2221 403 +2222 403 +2223 402 +2224 403 +2225 403 +2226 402 +2227 403 +2228 403 +2229 402 +2230 403 +2231 403 +2232 402 +2233 403 +2234 403 +2235 402 +2236 403 +2237 403 +2238 402 +2239 403 +2240 403 +2241 402 +2242 403 +2243 403 +2244 402 +2245 403 +2246 403 +2247 402 +2248 403 +2249 403 +2250 402 +2251 403 +2252 403 +2253 402 +2254 403 +2255 403 +2256 402 +2257 403 +2258 403 +2259 402 +2260 403 +2261 403 +2262 402 +2263 403 +2264 403 +2265 402 +2266 403 +2267 403 +2268 402 +2269 403 +2270 403 +2271 402 +2272 403 +2273 403 +2274 402 +2275 403 +2276 403 +2277 402 +2278 403 +2279 403 +2280 402 +2281 403 +2282 403 +2283 402 +2284 403 +2285 403 +2286 402 +2287 403 +2288 403 +2289 402 +2290 403 +2291 403 +2292 402 +2293 403 +2294 403 +2295 402 +2296 403 +2297 403 +2298 402 +2299 403 +2300 403 +2301 402 +2302 403 +2303 403 +2304 402 +2305 403 +2306 403 +2307 402 +2308 403 +2309 403 +2310 402 +2311 403 +2312 403 +2313 402 +2314 403 +2315 403 +2316 402 +2317 403 +2318 403 +2319 402 +2320 403 +2321 403 +2322 402 +2323 403 +2324 403 +2325 402 +2326 403 +2327 403 +2328 402 +2329 403 +2330 403 +2331 402 +2332 403 +2333 403 +2334 402 +2335 403 +2336 403 +2337 402 +2338 403 +2339 403 +2340 402 +2341 403 +2342 403 +2343 402 +2344 403 +2345 403 +2346 402 +2347 403 +2348 403 +2349 402 +2350 403 +2351 403 +2352 402 +2353 403 +2354 403 +2355 402 +2356 403 +2357 403 +2358 402 +2359 403 +2360 403 +2361 402 +2362 403 +2363 403 +2364 402 +2365 403 +2366 403 +2367 402 +2368 403 +2369 403 +2370 402 +2371 403 +2372 403 +2373 402 +2374 403 +2375 403 +2376 402 +2377 403 +2378 403 +2379 402 +2380 403 +2381 403 +2382 402 +2383 403 +2384 403 +2385 402 +2386 403 +2387 403 +2388 402 +2389 403 +2390 403 +2391 402 +2392 403 +2393 403 +2394 402 +2395 403 +2396 403 +2397 402 +2398 403 +2399 403 +2400 402 +2401 403 +2402 403 +2403 402 +2404 403 +2405 403 +2406 402 +2407 403 +2408 403 +2409 402 +2410 403 +2411 403 +2412 402 +2413 403 +2414 403 +2415 402 +2416 403 +2417 403 +2418 402 +2419 403 +2420 403 +2421 402 +2422 403 +2423 403 +2424 402 +2425 403 +2426 403 +2427 402 +2428 403 +2429 403 +2430 402 +2431 403 +2432 403 +2433 402 +2434 403 +2435 403 +2436 402 +2437 403 +2438 403 +2439 402 +2440 403 +2441 403 +2442 402 +2443 403 +2444 403 +2445 402 +2446 403 +2447 403 +2448 402 +2449 403 +2450 403 +2451 402 +2452 403 +2453 403 +2454 402 +2455 403 +2456 403 +2457 402 +2458 403 +2459 403 +2460 402 +2461 403 +2462 403 +2463 402 +2464 403 +2465 403 +2466 402 +2467 403 +2468 403 +2469 402 +2470 403 +2471 403 +2472 402 +2473 403 +2474 403 +2475 402 +2476 403 +2477 403 +2478 402 +2479 403 +2480 403 +2481 402 +2482 403 +2483 403 +2484 402 +2485 403 +2486 403 +2487 402 +2488 403 +2489 403 +2490 402 +2491 403 +2492 403 +2493 402 +2494 403 +2495 403 +2496 402 +2497 403 +2498 403 +2499 402 +2500 403 +2501 403 +2502 402 +2503 403 +2504 403 +2505 402 +2506 403 +2507 403 +2508 402 +2509 403 +2510 403 +2511 402 +2512 403 +2513 403 +2514 402 +2515 403 +2516 403 +2517 402 +2518 403 +2519 403 +2520 402 +2521 403 +2522 403 +2523 402 +2524 403 +2525 403 +2526 402 +2527 403 +2528 403 +2529 402 +2530 403 +2531 403 +2532 402 +2533 403 +2534 403 +2535 402 +2536 403 +2537 403 +2538 402 +2539 403 +2540 403 +2541 402 +2542 403 +2543 403 +2544 402 +2545 403 +2546 403 +2547 402 +2548 403 +2549 403 +2550 402 +2551 403 +2552 403 +2553 402 +2554 403 +2555 403 +2556 402 +2557 403 +2558 403 +2559 402 +2560 403 +2561 403 +2562 402 +2563 403 +2564 403 +2565 402 +2566 403 +2567 403 +2568 402 +2569 403 +2570 403 +2571 402 +2572 403 +2573 403 +2574 402 +2575 403 +2576 403 +2577 402 +2578 403 +2579 403 +2580 402 +2581 403 +2582 403 +2583 402 +2584 403 +2585 403 +2586 402 +2587 403 +2588 403 +2589 402 +2590 403 +2591 403 +2592 402 +2593 403 +2594 403 +2595 402 +2596 403 +2597 403 +2598 402 +2599 403 +2600 403 +2601 402 +2602 403 +2603 403 +2604 402 +2605 403 +2606 403 +2607 402 +2608 403 +2609 403 +2610 402 +2611 403 +2612 403 +2613 402 +2614 403 +2615 403 +2616 402 +2617 403 +2618 403 +2619 402 +2620 403 +2621 403 +2622 402 +2623 403 +2624 403 +2625 402 +2626 403 +2627 403 +2628 402 +2629 403 +2630 403 +2631 402 +2632 403 +2633 403 +2634 402 +2635 403 +2636 403 +2637 402 +2638 403 +2639 403 +2640 402 +2641 403 +2642 403 +2643 402 +2644 403 +2645 403 +2646 402 +2647 403 +2648 403 +2649 402 +2650 403 +2651 403 +2652 402 +2653 403 +2654 403 +2655 402 +2656 403 +2657 403 +2658 402 +2659 403 +2660 403 +2661 402 +2662 403 +2663 403 +2664 402 +2665 403 +2666 403 +2667 402 +2668 403 +2669 403 +2670 402 +2671 403 +2672 403 +2673 402 +2674 403 +2675 403 +2676 402 +2677 403 +2678 403 +2679 402 +2680 403 +2681 403 +2682 402 +2683 403 +2684 403 +2685 402 +2686 403 +2687 403 +2688 402 +2689 403 +2690 403 +2691 402 +2692 403 +2693 403 +2694 402 +2695 403 +2696 403 +2697 402 +2698 403 +2699 403 +2700 402 +2701 403 +2702 403 +2703 402 +2704 403 +2705 403 +2706 402 +2707 403 +2708 403 +2709 402 +2710 403 +2711 403 +2712 402 +2713 403 +2714 403 +2715 402 +2716 403 +2717 403 +2718 402 +2719 403 +2720 403 +2721 402 +2722 403 +2723 403 +2724 402 +2725 403 +2726 403 +2727 402 +2728 403 +2729 403 +2730 402 +2731 403 +2732 403 +2733 402 +2734 403 +2735 403 +2736 402 +2737 403 +2738 403 +2739 402 +2740 403 +2741 403 +2742 402 +2743 403 +2744 403 +2745 402 +2746 403 +2747 403 +2748 402 +2749 403 +2750 403 +2751 402 +2752 403 +2753 403 +2754 402 +2755 403 +2756 403 +2757 402 +2758 403 +2759 403 +2760 402 +2761 403 +2762 403 +2763 402 +2764 403 +2765 403 +2766 402 +2767 403 +2768 403 +2769 402 +2770 403 +2771 403 +2772 402 +2773 403 +2774 403 +2775 402 +2776 403 +2777 403 +2778 402 +2779 403 +2780 403 +2781 402 +2782 403 +2783 403 +2784 402 +2785 403 +2786 403 +2787 402 +2788 403 +2789 403 +2790 402 +2791 403 +2792 403 +2793 402 +2794 403 +2795 403 +2796 402 +2797 403 +2798 403 +2799 402 +2800 403 +2801 403 +2802 402 +2803 403 +2804 403 +2805 402 +2806 403 +2807 403 +2808 402 +2809 403 +2810 403 +2811 402 +2812 403 +2813 403 +2814 402 +2815 403 +2816 403 +2817 402 +2818 403 +2819 403 +2820 402 +2821 403 +2822 403 +2823 402 +2824 403 +2825 403 +2826 402 +2827 403 +2828 403 +2829 402 +2830 403 +2831 403 +2832 402 +2833 403 +2834 403 +2835 402 +2836 403 +2837 403 +2838 402 +2839 403 +2840 403 +2841 402 +2842 403 +2843 403 +2844 402 +2845 403 +2846 403 +2847 402 +2848 403 +2849 403 +2850 402 +2851 403 +2852 403 +2853 402 +2854 403 +2855 403 +2856 402 +2857 403 +2858 403 +2859 402 +2860 403 +2861 403 +2862 402 +2863 403 +2864 403 +2865 402 +2866 403 +2867 403 +2868 402 +2869 403 +2870 403 +2871 402 +2872 403 +2873 403 +2874 402 +2875 403 +2876 403 +2877 402 +2878 403 +2879 403 +2880 402 +2881 403 +2882 403 +2883 402 +2884 403 +2885 403 +2886 402 +2887 403 +2888 403 +2889 402 +2890 403 +2891 403 +2892 402 +2893 403 +2894 403 +2895 402 +2896 403 +2897 403 +2898 402 +2899 403 +2900 403 +2901 402 +2902 403 +2903 403 +2904 402 +2905 403 +2906 403 +2907 402 +2908 403 +2909 403 +2910 402 +2911 403 +2912 403 +2913 402 +2914 403 +2915 403 +2916 402 +2917 403 +2918 403 +2919 402 +2920 403 +2921 403 +2922 402 +2923 403 +2924 403 +2925 402 +2926 403 +2927 403 +2928 402 +2929 403 +2930 403 +2931 402 +2932 403 +2933 403 +2934 402 +2935 403 +2936 403 +2937 402 +2938 403 +2939 403 +2940 402 +2941 403 +2942 403 +2943 402 +2944 403 +2945 403 +2946 402 +2947 403 +2948 403 +2949 402 +2950 403 +2951 403 +2952 402 +2953 403 +2954 403 +2955 402 +2956 403 +2957 403 +2958 402 +2959 403 +2960 403 +2961 402 +2962 403 +2963 403 +2964 402 +2965 403 +2966 403 +2967 402 +2968 403 +2969 403 +2970 402 +2971 403 +2972 403 +2973 402 +2974 403 +2975 403 +2976 402 +2977 403 +2978 403 +2979 402 +2980 403 +2981 403 +2982 402 +2983 403 +2984 403 +2985 402 +2986 403 +2987 403 +2988 402 +2989 403 +2990 403 +2991 402 +2992 403 +2993 403 +2994 402 +2995 403 +2996 403 +2997 402 +2998 403 +2999 403 +3000 402 +3001 403 +3002 403 +3003 402 +3004 403 +3005 403 +3006 402 +3007 403 +3008 403 +3009 402 +3010 403 +3011 403 +3012 402 +3013 403 +3014 403 +3015 402 +3016 403 +3017 403 +3018 402 +3019 403 +3020 403 +3021 402 +3022 403 +3023 403 +3024 402 +3025 403 +3026 403 +3027 402 +3028 403 +3029 403 +3030 402 +3031 403 +3032 403 +3033 402 +3034 403 +3035 403 +3036 402 +3037 403 +3038 403 +3039 402 +3040 403 +3041 403 +3042 402 +3043 403 +3044 403 +3045 402 +3046 403 +3047 403 +3048 402 +3049 403 +3050 403 +3051 402 +3052 403 +3053 403 +3054 402 +3055 403 +3056 403 +3057 402 +3058 403 +3059 403 +3060 402 +3061 403 +3062 403 +3063 402 +3064 403 +3065 403 +3066 402 +3067 403 +3068 403 +3069 402 +3070 403 +3071 403 +3072 402 +3073 403 +3074 403 +3075 402 +3076 403 +3077 403 +3078 402 +3079 403 +3080 403 +3081 402 +3082 403 +3083 403 +3084 402 +3085 403 +3086 403 +3087 402 +3088 403 +3089 403 +3090 402 +3091 403 +3092 403 +3093 402 +3094 403 +3095 403 +3096 402 +3097 403 +3098 403 +3099 402 +3100 403 +3101 403 +3102 402 +3103 403 +3104 403 +3105 402 +3106 403 +3107 403 +3108 402 +3109 403 +3110 403 +3111 402 +3112 403 +3113 403 +3114 402 +3115 403 +3116 403 +3117 402 +3118 403 +3119 403 +3120 402 +3121 403 +3122 403 +3123 402 +3124 403 +3125 403 +3126 402 +3127 403 +3128 403 +3129 402 +3130 403 +3131 403 +3132 402 +3133 403 +3134 403 +3135 402 +3136 403 +3137 403 +3138 402 +3139 403 +3140 403 +3141 402 +3142 403 +3143 403 +3144 402 +3145 403 +3146 403 +3147 402 +3148 403 +3149 403 +3150 402 +3151 403 +3152 403 +3153 402 +3154 403 +3155 403 +3156 402 +3157 403 +3158 403 +3159 402 +3160 403 +3161 403 +3162 402 +3163 403 +3164 403 +3165 402 +3166 403 +3167 403 +3168 402 +3169 403 +3170 403 +3171 402 +3172 403 +3173 403 +3174 402 +3175 403 +3176 403 +3177 402 +3178 403 +3179 403 +3180 402 +3181 403 +3182 403 +3183 402 +3184 403 +3185 403 +3186 402 +3187 403 +3188 403 +3189 402 +3190 403 +3191 403 +3192 402 +3193 403 +3194 403 +3195 402 +3196 403 +3197 403 +3198 402 +3199 403 +3200 403 +3201 402 +3202 403 +3203 403 +3204 402 +3205 403 +3206 403 +3207 402 +3208 403 +3209 403 +3210 402 +3211 403 +3212 403 +3213 402 +3214 403 +3215 403 +3216 402 +3217 403 +3218 403 +3219 402 +3220 403 +3221 403 +3222 402 +3223 403 +3224 403 +3225 402 +3226 403 +3227 403 +3228 402 +3229 403 +3230 403 +3231 402 +3232 403 +3233 403 +3234 402 +3235 403 +3236 403 +3237 402 +3238 403 +3239 403 +3240 402 +3241 403 +3242 403 +3243 402 +3244 403 +3245 403 +3246 402 +3247 403 +3248 403 +3249 402 +3250 403 +3251 403 +3252 402 +3253 403 +3254 403 +3255 402 +3256 403 +3257 403 +3258 402 +3259 403 +3260 403 +3261 402 +3262 403 +3263 403 +3264 402 +3265 403 +3266 403 +3267 402 +3268 403 +3269 403 +3270 402 +3271 403 +3272 403 +3273 402 +3274 403 +3275 403 +3276 402 +3277 403 +3278 403 +3279 402 +3280 403 +3281 403 +3282 402 +3283 403 +3284 403 +3285 402 +3286 403 +3287 403 +3288 402 +3289 403 +3290 403 +3291 402 +3292 403 +3293 403 +3294 402 +3295 403 +3296 403 +3297 402 +3298 403 +3299 403 +3300 402 +3301 403 +3302 403 +3303 402 +3304 403 +3305 403 +3306 402 +3307 403 +3308 403 +3309 402 +3310 403 +3311 403 +3312 402 +3313 403 +3314 403 +3315 402 +3316 403 +3317 403 +3318 402 +3319 403 +3320 403 +3321 402 +3322 403 +3323 403 +3324 402 +3325 403 +3326 403 +3327 402 +3328 403 +3329 403 +3330 402 +3331 403 +3332 403 +3333 402 +3334 403 +3335 403 +3336 402 +3337 403 +3338 403 +3339 402 +3340 403 +3341 403 +3342 402 +3343 403 +3344 403 +3345 402 +3346 403 +3347 403 +3348 402 +3349 403 +3350 403 +3351 402 +3352 403 +3353 403 +3354 402 +3355 403 +3356 403 +3357 402 +3358 403 +3359 403 +3360 402 +3361 403 +3362 403 +3363 402 +3364 403 +3365 403 +3366 402 +3367 403 +3368 403 +3369 402 +3370 403 +3371 403 +3372 402 +3373 403 +3374 403 +3375 402 +3376 403 +3377 403 +3378 402 +3379 403 +3380 403 +3381 402 +3382 403 +3383 403 +3384 402 +3385 403 +3386 403 +3387 402 +3388 403 +3389 403 +3390 402 +3391 403 +3392 403 +3393 402 +3394 403 +3395 403 +3396 402 +3397 403 +3398 403 +3399 402 +3400 403 +3401 403 +3402 402 +3403 403 +3404 403 +3405 402 +3406 403 +3407 403 +3408 402 +3409 403 +3410 403 +3411 402 +3412 403 +3413 403 +3414 402 +3415 403 +3416 403 +3417 402 +3418 403 +3419 403 +3420 402 +3421 403 +3422 403 +3423 402 +3424 403 +3425 403 +3426 402 +3427 403 +3428 403 +3429 402 +3430 403 +3431 403 +3432 402 +3433 403 +3434 403 +3435 402 +3436 403 +3437 403 +3438 402 +3439 403 +3440 403 +3441 402 +3442 403 +3443 403 +3444 402 +3445 403 +3446 403 +3447 402 +3448 403 +3449 403 +3450 402 +3451 403 +3452 403 +3453 402 +3454 403 +3455 403 +3456 402 +3457 403 +3458 403 +3459 402 +3460 403 +3461 403 +3462 402 +3463 403 +3464 403 +3465 402 +3466 403 +3467 403 +3468 402 +3469 403 +3470 403 +3471 402 +3472 403 +3473 403 +3474 402 +3475 403 +3476 403 +3477 402 +3478 403 +3479 403 +3480 402 +3481 403 +3482 403 +3483 402 +3484 403 +3485 403 +3486 402 +3487 403 +3488 403 +3489 402 +3490 403 +3491 403 +3492 402 +3493 403 +3494 403 +3495 402 +3496 403 +3497 403 +3498 402 +3499 403 +3500 403 +3501 402 +3502 403 +3503 403 +3504 402 +3505 403 +3506 403 +3507 402 +3508 403 +3509 403 +3510 402 +3511 403 +3512 403 +3513 402 +3514 403 +3515 403 +3516 402 +3517 403 +3518 403 +3519 402 +3520 403 +3521 403 +3522 402 +3523 403 +3524 403 +3525 402 +3526 403 +3527 403 +3528 402 +3529 403 +3530 403 +3531 402 +3532 403 +3533 403 +3534 402 +3535 403 +3536 403 +3537 402 +3538 403 +3539 403 +3540 402 +3541 403 +3542 403 +3543 402 +3544 403 +3545 403 +3546 402 +3547 403 +3548 403 +3549 402 +3550 403 +3551 403 +3552 402 +3553 403 +3554 403 +3555 402 +3556 403 +3557 403 +3558 402 +3559 403 +3560 403 +3561 402 +3562 403 +3563 403 +3564 402 +3565 403 +3566 403 +3567 402 +3568 403 +3569 403 +3570 402 +3571 403 +3572 403 +3573 402 +3574 403 +3575 403 +3576 402 +3577 403 +3578 403 +3579 402 +3580 403 +3581 403 +3582 402 +3583 403 +3584 403 +3585 402 +3586 403 +3587 403 +3588 402 +3589 403 +3590 403 +3591 402 +3592 403 +3593 403 +3594 402 +3595 403 +3596 403 +3597 402 +3598 403 +3599 403 +3600 402 +3601 403 +3602 403 +3603 402 +3604 403 +3605 403 +3606 402 +3607 403 +3608 403 +3609 402 +3610 403 +3611 403 +3612 402 +3613 403 +3614 403 +3615 402 +3616 403 +3617 403 +3618 402 +3619 403 +3620 403 +3621 402 +3622 403 +3623 403 +3624 402 +3625 403 +3626 403 +3627 402 +3628 403 +3629 403 +3630 402 +3631 403 +3632 403 +3633 402 +3634 403 +3635 403 +3636 402 +3637 403 +3638 403 +3639 402 +3640 403 +3641 403 +3642 402 +3643 403 +3644 403 +3645 402 +3646 403 +3647 403 +3648 402 +3649 403 +3650 403 +3651 402 +3652 403 +3653 403 +3654 402 +3655 403 +3656 403 +3657 402 +3658 403 +3659 403 +3660 402 +3661 403 +3662 403 +3663 402 +3664 403 +3665 403 +3666 402 +3667 403 +3668 403 +3669 402 +3670 403 +3671 403 +3672 402 +3673 403 +3674 403 +3675 402 +3676 403 +3677 403 +3678 402 +3679 403 +3680 403 +3681 402 +3682 403 +3683 403 +3684 402 +3685 403 +3686 403 +3687 402 +3688 403 +3689 403 +3690 402 +3691 403 +3692 403 +3693 402 +3694 403 +3695 403 +3696 402 +3697 403 +3698 403 +3699 402 +3700 403 +3701 403 +3702 402 +3703 403 +3704 403 +3705 402 +3706 403 +3707 403 +3708 402 +3709 403 +3710 403 +3711 402 +3712 403 +3713 403 +3714 402 +3715 403 +3716 403 +3717 402 +3718 403 +3719 403 +3720 402 +3721 403 +3722 403 +3723 402 +3724 403 +3725 403 +3726 402 +3727 403 +3728 403 +3729 402 +3730 403 +3731 403 +3732 402 +3733 403 +3734 403 +3735 402 +3736 403 +3737 403 +3738 402 +3739 403 +3740 403 +3741 402 +3742 403 +3743 403 +3744 402 +3745 403 +3746 403 +3747 402 +3748 403 +3749 403 +3750 402 +3751 403 +3752 403 +3753 402 +3754 403 +3755 403 +3756 402 +3757 403 +3758 403 +3759 402 +3760 403 +3761 403 +3762 402 +3763 403 +3764 403 +3765 402 +3766 403 +3767 403 +3768 402 +3769 403 +3770 403 +3771 402 +3772 403 +3773 403 +3774 402 +3775 403 +3776 403 +3777 402 +3778 403 +3779 403 +3780 402 +3781 403 +3782 403 +3783 402 +3784 403 +3785 403 +3786 402 +3787 403 +3788 403 +3789 402 +3790 403 +3791 403 +3792 402 +3793 403 +3794 403 +3795 402 +3796 403 +3797 403 +3798 402 +3799 403 +3800 403 +3801 402 +3802 403 +3803 403 +3804 402 +3805 403 +3806 403 +3807 402 +3808 403 +3809 403 +3810 402 +3811 403 +3812 403 +3813 402 +3814 403 +3815 403 +3816 402 +3817 403 +3818 403 +3819 402 +3820 403 +3821 403 +3822 402 +3823 403 +3824 403 +3825 402 +3826 403 +3827 403 +3828 402 +3829 403 +3830 403 +3831 402 +3832 403 +3833 403 +3834 402 +3835 403 +3836 403 +3837 402 +3838 403 +3839 403 +3840 402 +3841 403 +3842 403 +3843 402 +3844 403 +3845 403 +3846 402 +3847 403 +3848 403 +3849 402 +3850 403 +3851 403 +3852 402 +3853 403 +3854 403 +3855 402 +3856 403 +3857 403 +3858 402 +3859 403 +3860 403 +3861 402 +3862 403 +3863 403 +3864 402 +3865 403 +3866 403 +3867 402 +3868 403 +3869 403 +3870 402 +3871 403 +3872 403 +3873 402 +3874 403 +3875 403 +3876 402 +3877 403 +3878 403 +3879 402 +3880 403 +3881 403 +3882 402 +3883 403 +3884 403 +3885 402 +3886 403 +3887 403 +3888 402 +3889 403 +3890 403 +3891 402 +3892 403 +3893 403 +3894 402 +3895 403 +3896 403 +3897 402 +3898 403 +3899 403 +3900 402 +3901 403 +3902 403 +3903 402 +3904 403 +3905 403 +3906 402 +3907 403 +3908 403 +3909 402 +3910 403 +3911 403 +3912 402 +3913 403 +3914 403 +3915 402 +3916 403 +3917 403 +3918 402 +3919 403 +3920 403 +3921 402 +3922 403 +3923 403 +3924 402 +3925 403 +3926 403 +3927 402 +3928 403 +3929 403 +3930 402 +3931 403 +3932 403 +3933 402 +3934 403 +3935 403 +3936 402 +3937 403 +3938 403 +3939 402 +3940 403 +3941 403 +3942 402 +3943 403 +3944 403 +3945 402 +3946 403 +3947 403 +3948 402 +3949 403 +3950 403 +3951 402 +3952 403 +3953 403 +3954 402 +3955 403 +3956 403 +3957 402 +3958 403 +3959 403 +3960 402 +3961 403 +3962 403 +3963 402 +3964 403 +3965 403 +3966 402 +3967 403 +3968 403 +3969 402 +3970 403 +3971 403 +3972 402 +3973 403 +3974 403 +3975 402 +3976 403 +3977 403 +3978 402 +3979 403 +3980 403 +3981 402 +3982 403 +3983 403 +3984 402 +3985 403 +3986 403 +3987 402 +3988 403 +3989 403 +3990 402 +3991 403 +3992 403 +3993 402 +3994 403 +3995 403 +3996 402 +3997 403 +3998 403 +3999 402 +4000 403 +4001 403 +4002 402 +4003 403 +4004 403 +4005 402 +4006 403 +4007 403 +4008 402 +4009 403 +4010 403 +4011 402 +4012 403 +4013 403 +4014 402 +4015 403 +4016 403 +4017 402 +4018 403 +4019 403 +4020 402 +4021 403 +4022 403 +4023 402 +4024 403 +4025 403 +4026 402 +4027 403 +4028 403 +4029 402 +4030 403 +4031 403 +4032 402 +4033 403 +4034 403 +4035 402 +4036 403 +4037 403 +4038 402 +4039 403 +4040 403 +4041 402 +4042 403 +4043 403 +4044 402 +4045 403 +4046 403 +4047 402 +4048 403 +4049 403 +4050 402 +4051 403 +4052 403 +4053 402 +4054 403 +4055 403 +4056 402 +4057 403 +4058 403 +4059 402 +4060 403 +4061 403 +4062 402 +4063 403 +4064 403 +4065 402 +4066 403 +4067 403 +4068 402 +4069 403 +4070 403 +4071 402 +4072 403 +4073 403 +4074 402 +4075 403 +4076 403 +4077 402 +4078 403 +4079 403 +4080 402 +4081 403 +4082 403 +4083 402 +4084 403 +4085 403 +4086 402 +4087 403 +4088 403 +4089 402 +4090 403 +4091 403 +4092 402 +4093 403 +4094 403 +4095 402 +4096 403 +4097 403 +4098 402 +4099 403 +4100 403 +4101 402 +4102 403 +4103 403 +4104 402 +4105 403 +4106 403 +4107 402 +4108 403 +4109 403 +4110 402 +4111 403 +4112 403 +4113 402 +4114 403 +4115 403 +4116 402 +4117 403 +4118 403 +4119 402 +4120 403 +4121 403 +4122 402 +4123 403 +4124 403 +4125 402 +4126 403 +4127 403 +4128 402 +4129 403 +4130 403 +4131 402 +4132 403 +4133 403 +4134 402 +4135 403 +4136 403 +4137 402 +4138 403 +4139 403 +4140 402 +4141 403 +4142 403 +4143 402 +4144 403 +4145 403 +4146 402 +4147 403 +4148 403 +4149 402 +4150 403 +4151 403 +4152 402 +4153 403 +4154 403 +4155 402 +4156 403 +4157 403 +4158 402 +4159 403 +4160 403 +4161 402 +4162 403 +4163 403 +4164 402 +4165 403 +4166 403 +4167 402 +4168 403 +4169 403 +4170 402 +4171 403 +4172 403 +4173 402 +4174 403 +4175 403 +4176 402 +4177 403 +4178 403 +4179 402 +4180 403 +4181 403 +4182 402 +4183 403 +4184 403 +4185 402 +4186 403 +4187 403 +4188 402 +4189 403 +4190 403 +4191 402 +4192 403 +4193 403 +4194 402 +4195 403 +4196 403 +4197 402 +4198 403 +4199 403 +4200 402 +4201 403 +4202 403 +4203 402 +4204 403 +4205 403 +4206 402 +4207 403 +4208 403 +4209 402 +4210 403 +4211 403 +4212 402 +4213 403 +4214 403 +4215 402 +4216 403 +4217 403 +4218 402 +4219 403 +4220 403 +4221 402 +4222 403 +4223 403 +4224 402 +4225 403 +4226 403 +4227 402 +4228 403 +4229 403 +4230 402 +4231 403 +4232 403 +4233 402 +4234 403 +4235 403 +4236 402 +4237 403 +4238 403 +4239 402 +4240 403 +4241 403 +4242 402 +4243 403 +4244 403 +4245 402 +4246 403 +4247 403 +4248 402 +4249 403 +4250 403 +4251 402 +4252 403 +4253 403 +4254 402 +4255 403 +4256 403 +4257 402 +4258 403 +4259 403 +4260 402 +4261 403 +4262 403 +4263 402 +4264 403 +4265 403 +4266 402 +4267 403 +4268 403 +4269 402 +4270 403 +4271 403 +4272 402 +4273 403 +4274 403 +4275 402 +4276 403 +4277 403 +4278 402 +4279 403 +4280 403 +4281 402 +4282 403 +4283 403 +4284 402 +4285 403 +4286 403 +4287 402 +4288 403 +4289 403 +4290 402 +4291 403 +4292 403 +4293 402 +4294 403 +4295 403 +4296 402 +4297 403 +4298 403 +4299 402 +4300 403 +4301 403 +4302 402 +4303 403 +4304 403 +4305 402 +4306 403 +4307 403 +4308 402 +4309 403 +4310 403 +4311 402 +4312 403 +4313 403 +4314 402 +4315 403 +4316 403 +4317 402 +4318 403 +4319 403 +4320 402 +4321 403 +4322 403 +4323 402 +4324 403 +4325 403 +4326 402 +4327 403 +4328 403 +4329 402 +4330 403 +4331 403 +4332 402 +4333 403 +4334 403 +4335 402 +4336 403 +4337 403 +4338 402 +4339 403 +4340 403 +4341 402 +4342 403 +4343 403 +4344 402 +4345 403 +4346 403 +4347 402 +4348 403 +4349 403 +4350 402 +4351 403 +4352 403 +4353 402 +4354 403 +4355 403 +4356 402 +4357 403 +4358 403 +4359 402 +4360 403 +4361 403 +4362 402 +4363 403 +4364 403 +4365 402 +4366 403 +4367 403 +4368 402 +4369 403 +4370 403 +4371 402 +4372 403 +4373 403 +4374 402 +4375 403 +4376 403 +4377 402 +4378 403 +4379 403 +4380 402 +4381 403 +4382 403 +4383 402 +4384 403 +4385 403 +4386 402 +4387 403 +4388 403 +4389 402 +4390 403 +4391 403 +4392 402 +4393 403 +4394 403 +4395 402 +4396 403 +4397 403 +4398 402 +4399 403 +4400 403 +4401 402 +4402 403 +4403 403 +4404 402 +4405 403 +4406 403 +4407 402 +4408 403 +4409 403 +4410 402 +4411 403 +4412 403 +4413 402 +4414 403 +4415 403 +4416 402 +4417 403 +4418 403 +4419 402 +4420 403 +4421 403 +4422 402 +4423 403 +4424 403 +4425 402 +4426 403 +4427 403 +4428 402 +4429 403 +4430 403 +4431 402 +4432 403 +4433 403 +4434 402 +4435 403 +4436 403 +4437 402 +4438 403 +4439 403 +4440 402 +4441 403 +4442 403 +4443 402 +4444 403 +4445 403 +4446 402 +4447 403 +4448 403 +4449 402 +4450 403 +4451 403 +4452 402 +4453 403 +4454 403 +4455 402 +4456 403 +4457 403 +4458 402 +4459 403 +4460 403 +4461 402 +4462 403 +4463 403 +4464 402 +4465 403 +4466 403 +4467 402 +4468 403 +4469 403 +4470 402 +4471 403 +4472 403 +4473 402 +4474 403 +4475 403 +4476 402 +4477 403 +4478 403 +4479 402 +4480 403 +4481 403 +4482 402 +4483 403 +4484 403 +4485 402 +4486 403 +4487 403 +4488 402 +4489 403 +4490 403 +4491 402 +4492 403 +4493 403 +4494 402 +4495 403 +4496 403 +4497 402 +4498 403 +4499 403 +4500 402 +4501 403 +4502 403 +4503 402 +4504 403 +4505 403 +4506 402 +4507 403 +4508 403 +4509 402 +4510 403 +4511 403 +4512 402 +4513 403 +4514 403 +4515 402 +4516 403 +4517 403 +4518 402 +4519 403 +4520 403 +4521 402 +4522 403 +4523 403 +4524 402 +4525 403 +4526 403 +4527 402 +4528 403 +4529 403 +4530 402 +4531 403 +4532 403 +4533 402 +4534 403 +4535 403 +4536 402 +4537 403 +4538 403 +4539 402 +4540 403 +4541 403 +4542 402 +4543 403 +4544 403 +4545 402 +4546 403 +4547 403 +4548 402 +4549 403 +4550 403 +4551 402 +4552 403 +4553 403 +4554 402 +4555 403 +4556 403 +4557 402 +4558 403 +4559 403 +4560 402 +4561 403 +4562 403 +4563 402 +4564 403 +4565 403 +4566 402 +4567 403 +4568 403 +4569 402 +4570 403 +4571 403 +4572 402 +4573 403 +4574 403 +4575 402 +4576 403 +4577 403 +4578 402 +4579 403 +4580 403 +4581 402 +4582 403 +4583 403 +4584 402 +4585 403 +4586 403 +4587 402 +4588 403 +4589 403 +4590 402 +4591 403 +4592 403 +4593 402 +4594 403 +4595 403 +4596 402 +4597 403 +4598 403 +4599 402 +4600 403 +4601 403 +4602 402 +4603 403 +4604 403 +4605 402 +4606 403 +4607 403 +4608 402 +4609 403 +4610 403 +4611 402 +4612 403 +4613 403 +4614 402 +4615 403 +4616 403 +4617 402 +4618 403 +4619 403 +4620 402 +4621 403 +4622 403 +4623 402 +4624 403 +4625 403 +4626 402 +4627 403 +4628 403 +4629 402 +4630 403 +4631 403 +4632 402 +4633 403 +4634 403 +4635 402 +4636 403 +4637 403 +4638 402 +4639 403 +4640 403 +4641 402 +4642 403 +4643 403 +4644 402 +4645 403 +4646 403 +4647 402 +4648 403 +4649 403 +4650 402 +4651 403 +4652 403 +4653 402 +4654 403 +4655 403 +4656 402 +4657 403 +4658 403 +4659 402 +4660 403 +4661 403 +4662 402 +4663 403 +4664 403 +4665 402 +4666 403 +4667 403 +4668 402 +4669 403 +4670 403 +4671 402 +4672 403 +4673 403 +4674 402 +4675 403 +4676 403 +4677 402 +4678 403 +4679 403 +4680 402 +4681 403 +4682 403 +4683 402 +4684 403 +4685 403 +4686 402 +4687 403 +4688 403 +4689 402 +4690 403 +4691 403 +4692 402 +4693 403 +4694 403 +4695 402 +4696 403 +4697 403 +4698 402 +4699 403 +4700 403 +4701 402 +4702 403 +4703 403 +4704 402 +4705 403 +4706 403 +4707 402 +4708 403 +4709 403 +4710 402 +4711 403 +4712 403 +4713 402 +4714 403 +4715 403 +4716 402 +4717 403 +4718 403 +4719 402 +4720 403 +4721 403 +4722 402 +4723 403 +4724 403 +4725 402 +4726 403 +4727 403 +4728 402 +4729 403 +4730 403 +4731 402 +4732 403 +4733 403 +4734 402 +4735 403 +4736 403 +4737 402 +4738 403 +4739 403 +4740 402 +4741 403 +4742 403 +4743 402 +4744 403 +4745 403 +4746 402 +4747 403 +4748 403 +4749 402 +4750 403 +4751 403 +4752 402 +4753 403 +4754 403 +4755 402 +4756 403 +4757 403 +4758 402 +4759 403 +4760 403 +4761 402 +4762 403 +4763 403 +4764 402 +4765 403 +4766 403 +4767 402 +4768 403 +4769 403 +4770 402 +4771 403 +4772 403 +4773 402 +4774 403 +4775 403 +4776 402 +4777 403 +4778 403 +4779 402 +4780 403 +4781 403 +4782 402 +4783 403 +4784 403 +4785 402 +4786 403 +4787 403 +4788 402 +4789 403 +4790 403 +4791 402 +4792 403 +4793 403 +4794 402 +4795 403 +4796 403 +4797 402 +4798 403 +4799 403 +4800 402 +4801 403 +4802 403 +4803 402 +4804 403 +4805 403 +4806 402 +4807 403 +4808 403 +4809 402 +4810 403 +4811 403 +4812 402 +4813 403 +4814 403 +4815 402 +4816 403 +4817 403 +4818 402 +4819 403 +4820 403 +4821 402 +4822 403 +4823 403 +4824 402 +4825 403 +4826 403 +4827 402 +4828 403 +4829 403 +4830 402 +4831 403 +4832 403 +4833 402 +4834 403 +4835 403 +4836 402 +4837 403 +4838 403 +4839 402 +4840 403 +4841 403 +4842 402 +4843 403 +4844 403 +4845 402 +4846 403 +4847 403 +4848 402 +4849 403 +4850 403 +4851 402 +4852 403 +4853 403 +4854 402 +4855 403 +4856 403 +4857 402 +4858 403 +4859 403 +4860 402 +4861 403 +4862 403 +4863 402 +4864 403 +4865 403 +4866 402 +4867 403 +4868 403 +4869 402 +4870 403 +4871 403 +4872 402 +4873 403 +4874 403 +4875 402 +4876 403 +4877 403 +4878 402 +4879 403 +4880 403 +4881 402 +4882 403 +4883 403 +4884 402 +4885 403 +4886 403 +4887 402 +4888 403 +4889 403 +4890 402 +4891 403 +4892 403 +4893 402 +4894 403 +4895 403 +4896 402 +4897 403 +4898 403 +4899 402 +4900 403 +4901 403 +4902 402 +4903 403 +4904 403 +4905 402 +4906 403 +4907 403 +4908 402 +4909 403 +4910 403 +4911 402 +4912 403 +4913 403 +4914 402 +4915 403 +4916 403 +4917 402 +4918 403 +4919 403 +4920 402 +4921 403 +4922 403 +4923 402 +4924 403 +4925 403 +4926 402 +4927 403 +4928 403 +4929 402 +4930 403 +4931 403 +4932 402 +4933 403 +4934 403 +4935 402 +4936 403 +4937 403 +4938 402 +4939 403 +4940 403 +4941 402 +4942 403 +4943 403 +4944 402 +4945 403 +4946 403 +4947 402 +4948 403 +4949 403 +4950 402 +4951 403 +4952 403 +4953 402 +4954 403 +4955 403 +4956 402 +4957 403 +4958 403 +4959 402 +4960 403 +4961 403 +4962 402 +4963 403 +4964 403 +4965 402 +4966 403 +4967 403 +4968 402 +4969 403 +4970 403 +4971 402 +4972 403 +4973 403 +4974 402 +4975 403 +4976 403 +4977 402 +4978 403 +4979 403 +4980 402 +4981 403 +4982 403 +4983 402 +4984 403 +4985 403 +4986 402 +4987 403 +4988 403 +4989 402 +4990 403 +4991 403 +4992 402 +4993 403 +4994 403 +4995 402 +4996 403 +4997 403 +4998 402 +4999 403 +5000 403 +5001 402 +5002 403 +5003 403 +5004 402 +5005 403 +5006 403 +5007 402 +5008 403 +5009 403 +5010 402 +5011 403 +5012 403 +5013 402 +5014 403 +5015 403 +5016 402 +5017 403 +5018 403 +5019 402 +5020 403 +5021 403 +5022 402 +5023 403 +5024 403 +5025 402 +5026 403 +5027 403 +5028 402 +5029 403 +5030 403 +5031 402 +5032 403 +5033 403 +5034 402 +5035 403 +5036 403 +5037 402 +5038 403 +5039 403 +5040 402 +5041 403 +5042 403 +5043 402 +5044 403 +5045 403 +5046 402 +5047 403 +5048 403 +5049 402 +5050 403 +5051 403 +5052 402 +5053 403 +5054 403 +5055 402 +5056 403 +5057 403 +5058 402 +5059 403 +5060 403 +5061 402 +5062 403 +5063 403 +5064 402 +5065 403 +5066 403 +5067 402 +5068 403 +5069 403 +5070 402 +5071 403 +5072 403 +5073 402 +5074 403 +5075 403 +5076 402 +5077 403 +5078 403 +5079 402 +5080 403 +5081 403 +5082 402 +5083 403 +5084 403 +5085 402 +5086 403 +5087 403 +5088 402 +5089 403 +5090 403 +5091 402 +5092 403 +5093 403 +5094 402 +5095 403 +5096 403 +5097 402 +5098 403 +5099 403 +5100 402 +5101 403 +5102 403 +5103 402 +5104 403 +5105 403 +5106 402 +5107 403 +5108 403 +5109 402 +5110 403 +5111 403 +5112 402 +5113 403 +5114 403 +5115 402 +5116 403 +5117 403 +5118 402 +5119 403 +5120 403 +5121 402 +5122 403 +5123 403 +5124 402 +5125 403 +5126 403 +5127 402 +5128 403 +5129 403 +5130 402 +5131 403 +5132 403 +5133 402 +5134 403 +5135 403 +5136 402 +5137 403 +5138 403 +5139 402 +5140 403 +5141 403 +5142 402 +5143 403 +5144 403 +5145 402 +5146 403 +5147 403 +5148 402 +5149 403 +5150 403 +5151 402 +5152 403 +5153 403 +5154 402 +5155 403 +5156 403 +5157 402 +5158 403 +5159 403 +5160 402 +5161 403 +5162 403 +5163 402 +5164 403 +5165 403 +5166 402 +5167 403 +5168 403 +5169 402 +5170 403 +5171 403 +5172 402 +5173 403 +5174 403 +5175 402 +5176 403 +5177 403 +5178 402 +5179 403 +5180 403 +5181 402 +5182 403 +5183 403 +5184 402 +5185 403 +5186 403 +5187 402 +5188 403 +5189 403 +5190 402 +5191 403 +5192 403 +5193 402 +5194 403 +5195 403 +5196 402 +5197 403 +5198 403 +5199 402 +5200 403 +5201 403 +5202 402 +5203 403 +5204 403 +5205 402 +5206 403 +5207 403 +5208 402 +5209 403 +5210 403 +5211 402 +5212 403 +5213 403 +5214 402 +5215 403 +5216 403 +5217 402 +5218 403 +5219 403 +5220 402 +5221 403 +5222 403 +5223 402 +5224 403 +5225 403 +5226 402 +5227 403 +5228 403 +5229 402 +5230 403 +5231 403 +5232 402 +5233 403 +5234 403 +5235 402 +5236 403 +5237 403 +5238 402 +5239 403 +5240 403 +5241 402 +5242 403 +5243 403 +5244 402 +5245 403 +5246 403 +5247 402 +5248 403 +5249 403 +5250 402 +5251 403 +5252 403 +5253 402 +5254 403 +5255 403 +5256 402 +5257 403 +5258 403 +5259 402 +5260 403 +5261 403 +5262 402 +5263 403 +5264 403 +5265 402 +5266 403 +5267 403 +5268 402 +5269 403 +5270 403 +5271 402 +5272 403 +5273 403 +5274 402 +5275 403 +5276 403 +5277 402 +5278 403 +5279 403 +5280 402 +5281 403 +5282 403 +5283 402 +5284 403 +5285 403 +5286 402 +5287 403 +5288 403 +5289 402 +5290 403 +5291 403 +5292 402 +5293 403 +5294 403 +5295 402 +5296 403 +5297 403 +5298 402 +5299 403 +5300 403 +5301 402 +5302 403 +5303 403 +5304 402 +5305 403 +5306 403 +5307 402 +5308 403 +5309 403 +5310 402 +5311 403 +5312 403 +5313 402 +5314 403 +5315 403 +5316 402 +5317 403 +5318 403 +5319 402 +5320 403 +5321 403 +5322 402 +5323 403 +5324 403 +5325 402 +5326 403 +5327 403 +5328 402 +5329 403 +5330 403 +5331 402 +5332 403 +5333 403 +5334 402 +5335 403 +5336 403 +5337 402 +5338 403 +5339 403 +5340 402 +5341 403 +5342 403 +5343 402 +5344 403 +5345 403 +5346 402 +5347 403 +5348 403 +5349 402 +5350 403 +5351 403 +5352 402 +5353 403 +5354 403 +5355 402 +5356 403 +5357 403 +5358 402 +5359 403 +5360 403 +5361 402 +5362 403 +5363 403 +5364 402 +5365 403 +5366 403 +5367 402 +5368 403 +5369 403 +5370 402 +5371 403 +5372 403 +5373 402 +5374 403 +5375 403 +5376 402 +5377 403 +5378 403 +5379 402 +5380 403 +5381 403 +5382 402 +5383 403 +5384 403 +5385 402 +5386 403 +5387 403 +5388 402 +5389 403 +5390 403 +5391 402 +5392 403 +5393 403 +5394 402 +5395 403 +5396 403 +5397 402 +5398 403 +5399 403 +5400 402 +5401 403 +5402 403 +5403 402 +5404 403 +5405 403 +5406 402 +5407 403 +5408 403 +5409 402 +5410 403 +5411 403 +5412 402 +5413 403 +5414 403 +5415 402 +5416 403 +5417 403 +5418 402 +5419 403 +5420 403 +5421 402 +5422 403 +5423 403 +5424 402 +5425 403 +5426 403 +5427 402 +5428 403 +5429 403 +5430 402 +5431 403 +5432 403 +5433 402 +5434 403 +5435 403 +5436 402 +5437 403 +5438 403 +5439 402 +5440 403 +5441 403 +5442 402 +5443 403 +5444 403 +5445 402 +5446 403 +5447 403 +5448 402 +5449 403 +5450 403 +5451 402 +5452 403 +5453 403 +5454 402 +5455 403 +5456 403 +5457 402 +5458 403 +5459 403 +5460 402 +5461 403 +5462 403 +5463 402 +5464 403 +5465 403 +5466 402 +5467 403 +5468 403 +5469 402 +5470 403 +5471 403 +5472 402 +5473 403 +5474 403 +5475 402 +5476 403 +5477 403 +5478 402 +5479 403 +5480 403 +5481 402 +5482 403 +5483 403 +5484 402 +5485 403 +5486 403 +5487 402 +5488 403 +5489 403 +5490 402 +5491 403 +5492 403 +5493 402 +5494 403 +5495 403 +5496 402 +5497 403 +5498 403 +5499 402 +5500 403 +5501 403 +5502 402 +5503 403 +5504 403 +5505 402 +5506 403 +5507 403 +5508 402 +5509 403 +5510 403 +5511 402 +5512 403 +5513 403 +5514 402 +5515 403 +5516 403 +5517 402 +5518 403 +5519 403 +5520 402 +5521 403 +5522 403 +5523 402 +5524 403 +5525 403 +5526 402 +5527 403 +5528 403 +5529 402 +5530 403 +5531 403 +5532 402 +5533 403 +5534 403 +5535 402 +5536 403 +5537 403 +5538 402 +5539 403 +5540 403 +5541 402 +5542 403 +5543 403 +5544 402 +5545 403 +5546 403 +5547 402 +5548 403 +5549 403 +5550 402 +5551 403 +5552 403 +5553 402 +5554 403 +5555 403 +5556 402 +5557 403 +5558 403 +5559 402 +5560 403 +5561 403 +5562 402 +5563 403 +5564 403 +5565 402 +5566 403 +5567 403 +5568 402 +5569 403 +5570 403 +5571 402 +5572 403 +5573 403 +5574 402 +5575 403 +5576 403 +5577 402 +5578 403 +5579 403 +5580 402 +5581 403 +5582 403 +5583 402 +5584 403 +5585 403 +5586 402 +5587 403 +5588 403 +5589 402 +5590 403 +5591 403 +5592 402 +5593 403 +5594 403 +5595 402 +5596 403 +5597 403 +5598 402 +5599 403 +5600 403 +5601 402 +5602 403 +5603 403 +5604 402 +5605 403 +5606 403 +5607 402 +5608 403 +5609 403 +5610 402 +5611 403 +5612 403 +5613 402 +5614 403 +5615 403 +5616 402 +5617 403 +5618 403 +5619 402 +5620 403 +5621 403 +5622 402 +5623 403 +5624 403 +5625 402 +5626 403 +5627 403 +5628 402 +5629 403 +5630 403 +5631 402 +5632 403 +5633 403 +5634 402 +5635 403 +5636 403 +5637 402 +5638 403 +5639 403 +5640 402 +5641 403 +5642 403 +5643 402 +5644 403 +5645 403 +5646 402 +5647 403 +5648 403 +5649 402 +5650 403 +5651 403 +5652 402 +5653 403 +5654 403 +5655 402 +5656 403 +5657 403 +5658 402 +5659 403 +5660 403 +5661 402 +5662 403 +5663 403 +5664 402 +5665 403 +5666 403 +5667 402 +5668 403 +5669 403 +5670 402 +5671 403 +5672 403 +5673 402 +5674 403 +5675 403 +5676 402 +5677 403 +5678 403 +5679 402 +5680 403 +5681 403 +5682 402 +5683 403 +5684 403 +5685 402 +5686 403 +5687 403 +5688 402 +5689 403 +5690 403 +5691 402 +5692 403 +5693 403 +5694 402 +5695 403 +5696 403 +5697 402 +5698 403 +5699 403 +5700 402 +5701 403 +5702 403 +5703 402 +5704 403 +5705 403 +5706 402 +5707 403 +5708 403 +5709 402 +5710 403 +5711 403 +5712 402 +5713 403 +5714 403 +5715 402 +5716 403 +5717 403 +5718 402 +5719 403 +5720 403 +5721 402 +5722 403 +5723 403 +5724 402 +5725 403 +5726 403 +5727 402 +5728 403 +5729 403 +5730 402 +5731 403 +5732 403 +5733 402 +5734 403 +5735 403 +5736 402 +5737 403 +5738 403 +5739 402 +5740 403 +5741 403 +5742 402 +5743 403 +5744 403 +5745 402 +5746 403 +5747 403 +5748 402 +5749 403 +5750 403 +5751 402 +5752 403 +5753 403 +5754 402 +5755 403 +5756 403 +5757 402 +5758 403 +5759 403 +5760 402 +5761 403 +5762 403 +5763 402 +5764 403 +5765 403 +5766 402 +5767 403 +5768 403 +5769 402 +5770 403 +5771 403 +5772 402 +5773 403 +5774 403 +5775 402 +5776 403 +5777 403 +5778 402 +5779 403 +5780 403 +5781 402 +5782 403 +5783 403 +5784 402 +5785 403 +5786 403 +5787 402 +5788 403 +5789 403 +5790 402 +5791 403 +5792 403 +5793 402 +5794 403 +5795 403 +5796 402 +5797 403 +5798 403 +5799 402 +5800 403 +5801 403 +5802 402 +5803 403 +5804 403 +5805 402 +5806 403 +5807 403 +5808 402 +5809 403 +5810 403 +5811 402 +5812 403 +5813 403 +5814 402 +5815 403 +5816 403 +5817 402 +5818 403 +5819 403 +5820 402 +5821 403 +5822 403 +5823 402 +5824 403 +5825 403 +5826 402 +5827 403 +5828 403 +5829 402 +5830 403 +5831 403 +5832 402 +5833 403 +5834 403 +5835 402 +5836 403 +5837 403 +5838 402 +5839 403 +5840 403 +5841 402 +5842 403 +5843 403 +5844 402 +5845 403 +5846 403 +5847 402 +5848 403 +5849 403 +5850 402 +5851 403 +5852 403 +5853 402 +5854 403 +5855 403 +5856 402 +5857 403 +5858 403 +5859 402 +5860 403 +5861 403 +5862 402 +5863 403 +5864 403 +5865 402 +5866 403 +5867 403 +5868 402 +5869 403 +5870 403 +5871 402 +5872 403 +5873 403 +5874 402 +5875 403 +5876 403 +5877 402 +5878 403 +5879 403 +5880 402 +5881 403 +5882 403 +5883 402 +5884 403 +5885 403 +5886 402 +5887 403 +5888 403 +5889 402 +5890 403 +5891 403 +5892 402 +5893 403 +5894 403 +5895 402 +5896 403 +5897 403 +5898 402 +5899 403 +5900 403 +5901 402 +5902 403 +5903 403 +5904 402 +5905 403 +5906 403 +5907 402 +5908 403 +5909 403 +5910 402 +5911 403 +5912 403 +5913 402 +5914 403 +5915 403 +5916 402 +5917 403 +5918 403 +5919 402 +5920 403 +5921 403 +5922 402 +5923 403 +5924 403 +5925 402 +5926 403 +5927 403 +5928 402 +5929 403 +5930 403 +5931 402 +5932 403 +5933 403 +5934 402 +5935 403 +5936 403 +5937 402 +5938 403 +5939 403 +5940 402 +5941 403 +5942 403 +5943 402 +5944 403 +5945 403 +5946 402 +5947 403 +5948 403 +5949 402 +5950 403 +5951 403 +5952 402 +5953 403 +5954 403 +5955 402 +5956 403 +5957 403 +5958 402 +5959 403 +5960 403 +5961 402 +5962 403 +5963 403 +5964 402 +5965 403 +5966 403 +5967 402 +5968 403 +5969 403 +5970 402 +5971 403 +5972 403 +5973 402 +5974 403 +5975 403 +5976 402 +5977 403 +5978 403 +5979 402 +5980 403 +5981 403 +5982 402 +5983 403 +5984 403 +5985 402 +5986 403 +5987 403 +5988 402 +5989 403 +5990 403 +5991 402 +5992 403 +5993 403 +5994 402 +5995 403 +5996 403 +5997 402 +5998 403 +5999 403 +6000 402 +6001 403 +6002 403 +6003 402 +6004 403 +6005 403 +6006 402 +6007 403 +6008 403 +6009 402 +6010 403 +6011 403 +6012 402 +6013 403 +6014 403 +6015 402 +6016 403 +6017 403 +6018 402 +6019 403 +6020 403 +6021 402 +6022 403 +6023 403 +6024 402 +6025 403 +6026 403 +6027 402 +6028 403 +6029 403 +6030 402 +6031 403 +6032 403 +6033 402 +6034 403 +6035 403 +6036 402 +6037 403 +6038 403 +6039 402 +6040 403 +6041 403 +6042 402 +6043 403 +6044 403 +6045 402 +6046 403 +6047 403 +6048 402 +6049 403 +6050 403 +6051 402 +6052 403 +6053 403 +6054 402 +6055 403 +6056 403 +6057 402 +6058 403 +6059 403 +6060 402 +6061 403 +6062 403 +6063 402 +6064 403 +6065 403 +6066 402 +6067 403 +6068 403 +6069 402 +6070 403 +6071 403 +6072 402 +6073 403 +6074 403 +6075 402 +6076 403 +6077 403 +6078 402 +6079 403 +6080 403 +6081 402 +6082 403 +6083 403 +6084 402 +6085 403 +6086 403 +6087 402 +6088 403 +6089 403 +6090 402 +6091 403 +6092 403 +6093 402 +6094 403 +6095 403 +6096 402 +6097 403 +6098 403 +6099 402 +6100 403 +6101 403 +6102 402 +6103 403 +6104 403 +6105 402 +6106 403 +6107 403 +6108 402 +6109 403 +6110 403 +6111 402 +6112 403 +6113 403 +6114 402 +6115 403 +6116 403 +6117 402 +6118 403 +6119 403 +6120 402 +6121 403 +6122 403 +6123 402 +6124 403 +6125 403 +6126 402 +6127 403 +6128 403 +6129 402 +6130 403 +6131 403 +6132 402 +6133 403 +6134 403 +6135 402 +6136 403 +6137 403 +6138 402 +6139 403 +6140 403 +6141 402 +6142 403 +6143 403 +6144 402 +6145 403 +6146 403 +6147 402 +6148 403 +6149 403 +6150 402 +6151 403 +6152 403 +6153 402 +6154 403 +6155 403 +6156 402 +6157 403 +6158 403 +6159 402 +6160 403 +6161 403 +6162 402 +6163 403 +6164 403 +6165 402 +6166 403 +6167 403 +6168 402 +6169 403 +6170 403 +6171 402 +6172 403 +6173 403 +6174 402 +6175 403 +6176 403 +6177 402 +6178 403 +6179 403 +6180 402 +6181 403 +6182 403 +6183 402 +6184 403 +6185 403 +6186 402 +6187 403 +6188 403 +6189 402 +6190 403 +6191 403 +6192 402 +6193 403 +6194 403 +6195 402 +6196 403 +6197 403 +6198 402 +6199 403 +6200 403 +6201 402 +6202 403 +6203 403 +6204 402 +6205 403 +6206 403 +6207 402 +6208 403 +6209 403 +6210 402 +6211 403 +6212 403 +6213 402 +6214 403 +6215 403 +6216 402 +6217 403 +6218 403 +6219 402 +6220 403 +6221 403 +6222 402 +6223 403 +6224 403 +6225 402 +6226 403 +6227 403 +6228 402 +6229 403 +6230 403 +6231 402 +6232 403 +6233 403 +6234 402 +6235 403 +6236 403 +6237 402 +6238 403 +6239 403 +6240 402 +6241 403 +6242 403 +6243 402 +6244 403 +6245 403 +6246 402 +6247 403 +6248 403 +6249 402 +6250 403 +6251 403 +6252 402 +6253 403 +6254 403 +6255 402 +6256 403 +6257 403 +6258 402 +6259 403 +6260 403 +6261 402 +6262 403 +6263 403 +6264 402 +6265 403 +6266 403 +6267 402 +6268 403 +6269 403 +6270 402 +6271 403 +6272 403 +6273 402 +6274 403 +6275 403 +6276 402 +6277 403 +6278 403 +6279 402 +6280 403 +6281 403 +6282 402 +6283 403 +6284 403 +6285 402 +6286 403 +6287 403 +6288 402 +6289 403 +6290 403 +6291 402 +6292 403 +6293 403 +6294 402 +6295 403 +6296 403 +6297 402 +6298 403 +6299 403 +6300 402 +6301 403 +6302 403 +6303 402 +6304 403 +6305 403 +6306 402 +6307 403 +6308 403 +6309 402 +6310 403 +6311 403 +6312 402 +6313 403 +6314 403 +6315 402 +6316 403 +6317 403 +6318 402 +6319 403 +6320 403 +6321 402 +6322 403 +6323 403 +6324 402 +6325 403 +6326 403 +6327 402 +6328 403 +6329 403 +6330 402 +6331 403 +6332 403 +6333 402 +6334 403 +6335 403 +6336 402 +6337 403 +6338 403 +6339 402 +6340 403 +6341 403 +6342 402 +6343 403 +6344 403 +6345 402 +6346 403 +6347 403 +6348 402 +6349 403 +6350 403 +6351 402 +6352 403 +6353 403 +6354 402 +6355 403 +6356 403 +6357 402 +6358 403 +6359 403 +6360 402 +6361 403 +6362 403 +6363 402 +6364 403 +6365 403 +6366 402 +6367 403 +6368 403 +6369 402 +6370 403 +6371 403 +6372 402 +6373 403 +6374 403 +6375 402 +6376 403 +6377 403 +6378 402 +6379 403 +6380 403 +6381 402 +6382 403 +6383 403 +6384 402 +6385 403 +6386 403 +6387 402 +6388 403 +6389 403 +6390 402 +6391 403 +6392 403 +6393 402 +6394 403 +6395 403 +6396 402 +6397 403 +6398 403 +6399 402 +6400 403 +6401 403 +6402 402 +6403 403 +6404 403 +6405 402 +6406 403 +6407 403 +6408 402 +6409 403 +6410 403 +6411 402 +6412 403 +6413 403 +6414 402 +6415 403 +6416 403 +6417 402 +6418 403 +6419 403 +6420 402 +6421 403 +6422 403 +6423 402 +6424 403 +6425 403 +6426 402 +6427 403 +6428 403 +6429 402 +6430 403 +6431 403 +6432 402 +6433 403 +6434 403 +6435 402 +6436 403 +6437 403 +6438 402 +6439 403 +6440 403 +6441 402 +6442 403 +6443 403 +6444 402 +6445 403 +6446 403 +6447 402 +6448 403 +6449 403 +6450 402 +6451 403 +6452 403 +6453 402 +6454 403 +6455 403 +6456 402 +6457 403 +6458 403 +6459 402 +6460 403 +6461 403 +6462 402 +6463 403 +6464 403 +6465 402 +6466 403 +6467 403 +6468 402 +6469 403 +6470 403 +6471 402 +6472 403 +6473 403 +6474 402 +6475 403 +6476 403 +6477 402 +6478 403 +6479 403 +6480 402 +6481 403 +6482 403 +6483 402 +6484 403 +6485 403 +6486 402 +6487 403 +6488 403 +6489 402 +6490 403 +6491 403 +6492 402 +6493 403 +6494 403 +6495 402 +6496 403 +6497 403 +6498 402 +6499 403 +6500 403 +6501 402 +6502 403 +6503 403 +6504 402 +6505 403 +6506 403 +6507 402 +6508 403 +6509 403 +6510 402 +6511 403 +6512 403 +6513 402 +6514 403 +6515 403 +6516 402 +6517 403 +6518 403 +6519 402 +6520 403 +6521 403 +6522 402 +6523 403 +6524 403 +6525 402 +6526 403 +6527 403 +6528 402 +6529 403 +6530 403 +6531 402 +6532 403 +6533 403 +6534 402 +6535 403 +6536 403 +6537 402 +6538 403 +6539 403 +6540 402 +6541 403 +6542 403 +6543 402 +6544 403 +6545 403 +6546 402 +6547 403 +6548 403 +6549 402 +6550 403 +6551 403 +6552 402 +6553 403 +6554 403 +6555 402 +6556 403 +6557 403 +6558 402 +6559 403 +6560 403 +6561 402 +6562 403 +6563 403 +6564 402 +6565 403 +6566 403 +6567 402 +6568 403 +6569 403 +6570 402 +6571 403 +6572 403 +6573 402 +6574 403 +6575 403 +6576 402 +6577 403 +6578 403 +6579 402 +6580 403 +6581 403 +6582 402 +6583 403 +6584 403 +6585 402 +6586 403 +6587 403 +6588 402 +6589 403 +6590 403 +6591 402 +6592 403 +6593 403 +6594 402 +6595 403 +6596 403 +6597 402 +6598 403 +6599 403 +6600 402 +6601 403 +6602 403 +6603 402 +6604 403 +6605 403 +6606 402 +6607 403 +6608 403 +6609 402 +6610 403 +6611 403 +6612 402 +6613 403 +6614 403 +6615 402 +6616 403 +6617 403 +6618 402 +6619 403 +6620 403 +6621 402 +6622 403 +6623 403 +6624 402 +6625 403 +6626 403 +6627 402 +6628 403 +6629 403 +6630 402 +6631 403 +6632 403 +6633 402 +6634 403 +6635 403 +6636 402 +6637 403 +6638 403 +6639 402 +6640 403 +6641 403 +6642 402 +6643 403 +6644 403 +6645 402 +6646 403 +6647 403 +6648 402 +6649 403 +6650 403 +6651 402 +6652 403 +6653 403 +6654 402 +6655 403 +6656 403 +6657 402 +6658 403 +6659 403 +6660 402 +6661 403 +6662 403 +6663 402 +6664 403 +6665 403 +6666 402 +6667 403 +6668 403 +6669 402 +6670 403 +6671 403 +6672 402 +6673 403 +6674 403 +6675 402 +6676 403 +6677 403 +6678 402 +6679 403 +6680 403 +6681 402 +6682 403 +6683 403 +6684 402 +6685 403 +6686 403 +6687 402 +6688 403 +6689 403 +6690 402 +6691 403 +6692 403 +6693 402 +6694 403 +6695 403 +6696 402 +6697 403 +6698 403 +6699 402 +6700 403 +6701 403 +6702 402 +6703 403 +6704 403 +6705 402 +6706 403 +6707 403 +6708 402 +6709 403 +6710 403 +6711 402 +6712 403 +6713 403 +6714 402 +6715 403 +6716 403 +6717 402 +6718 403 +6719 403 +6720 402 +6721 403 +6722 403 +6723 402 +6724 403 +6725 403 +6726 402 +6727 403 +6728 403 +6729 402 +6730 403 +6731 403 +6732 402 +6733 403 +6734 403 +6735 402 +6736 403 +6737 403 +6738 402 +6739 403 +6740 403 +6741 402 +6742 403 +6743 403 +6744 402 +6745 403 +6746 403 +6747 402 +6748 403 +6749 403 +6750 402 +6751 403 +6752 403 +6753 402 +6754 403 +6755 403 +6756 402 +6757 403 +6758 403 +6759 402 +6760 403 +6761 403 +6762 402 +6763 403 +6764 403 +6765 402 +6766 403 +6767 403 +6768 402 +6769 403 +6770 403 +6771 402 +6772 403 +6773 403 +6774 402 +6775 403 +6776 403 +6777 402 +6778 403 +6779 403 +6780 402 +6781 403 +6782 403 +6783 402 +6784 403 +6785 403 +6786 402 +6787 403 +6788 403 +6789 402 +6790 403 +6791 403 +6792 402 +6793 403 +6794 403 +6795 402 +6796 403 +6797 403 +6798 402 +6799 403 +6800 403 +6801 402 +6802 403 +6803 403 +6804 402 +6805 403 +6806 403 +6807 402 +6808 403 +6809 403 +6810 402 +6811 403 +6812 403 +6813 402 +6814 403 +6815 403 +6816 402 +6817 403 +6818 403 +6819 402 +6820 403 +6821 403 +6822 402 +6823 403 +6824 403 +6825 402 +6826 403 +6827 403 +6828 402 +6829 403 +6830 403 +6831 402 +6832 403 +6833 403 +6834 402 +6835 403 +6836 403 +6837 402 +6838 403 +6839 403 +6840 402 +6841 403 +6842 403 +6843 402 +6844 403 +6845 403 +6846 402 +6847 403 +6848 403 +6849 402 +6850 403 +6851 403 +6852 402 +6853 403 +6854 403 +6855 402 +6856 403 +6857 403 +6858 402 +6859 403 +6860 403 +6861 402 +6862 403 +6863 403 +6864 402 +6865 403 +6866 403 +6867 402 +6868 403 +6869 403 +6870 402 +6871 403 +6872 403 +6873 402 +6874 403 +6875 403 +6876 402 +6877 403 +6878 403 +6879 402 +6880 403 +6881 403 +6882 402 +6883 403 +6884 403 +6885 402 +6886 403 +6887 403 +6888 402 +6889 403 +6890 403 +6891 402 +6892 403 +6893 403 +6894 402 +6895 403 +6896 403 +6897 402 +6898 403 +6899 403 +6900 402 +6901 403 +6902 403 +6903 402 +6904 403 +6905 403 +6906 402 +6907 403 +6908 403 +6909 402 +6910 403 +6911 403 +6912 402 +6913 403 +6914 403 +6915 402 +6916 403 +6917 403 +6918 402 +6919 403 +6920 403 +6921 402 +6922 403 +6923 403 +6924 402 +6925 403 +6926 403 +6927 402 +6928 403 +6929 403 +6930 402 +6931 403 +6932 403 +6933 402 +6934 403 +6935 403 +6936 402 +6937 403 +6938 403 +6939 402 +6940 403 +6941 403 +6942 402 +6943 403 +6944 403 +6945 402 +6946 403 +6947 403 +6948 402 +6949 403 +6950 403 +6951 402 +6952 403 +6953 403 +6954 402 +6955 403 +6956 403 +6957 402 +6958 403 +6959 403 +6960 402 +6961 403 +6962 403 +6963 402 +6964 403 +6965 403 +6966 402 +6967 403 +6968 403 +6969 402 +6970 403 +6971 403 +6972 402 +6973 403 +6974 403 +6975 402 +6976 403 +6977 403 +6978 402 +6979 403 +6980 403 +6981 402 +6982 403 +6983 403 +6984 402 +6985 403 +6986 403 +6987 402 +6988 403 +6989 403 +6990 402 +6991 403 +6992 403 +6993 402 +6994 403 +6995 403 +6996 402 +6997 403 +6998 403 +6999 402 +7000 403 +7001 403 +7002 402 +7003 403 +7004 403 +7005 402 +7006 403 +7007 403 +7008 402 +7009 403 +7010 403 +7011 402 +7012 403 +7013 403 +7014 402 +7015 403 +7016 403 +7017 402 +7018 403 +7019 403 +7020 402 +7021 403 +7022 403 +7023 402 +7024 403 +7025 403 +7026 402 +7027 403 +7028 403 +7029 402 +7030 403 +7031 403 +7032 402 +7033 403 +7034 403 +7035 402 +7036 403 +7037 403 +7038 402 +7039 403 +7040 403 +7041 402 +7042 403 +7043 403 +7044 402 +7045 403 +7046 403 +7047 402 +7048 403 +7049 403 +7050 402 +7051 403 +7052 403 +7053 402 +7054 403 +7055 403 +7056 402 +7057 403 +7058 403 +7059 402 +7060 403 +7061 403 +7062 402 +7063 403 +7064 403 +7065 402 +7066 403 +7067 403 +7068 402 +7069 403 +7070 403 +7071 402 +7072 403 +7073 403 +7074 402 +7075 403 +7076 403 +7077 402 +7078 403 +7079 403 +7080 402 +7081 403 +7082 403 +7083 402 +7084 403 +7085 403 +7086 402 +7087 403 +7088 403 +7089 402 +7090 403 +7091 403 +7092 402 +7093 403 +7094 403 +7095 402 +7096 403 +7097 403 +7098 402 +7099 403 +7100 403 +7101 402 +7102 403 +7103 403 +7104 402 +7105 403 +7106 403 +7107 402 +7108 403 +7109 403 +7110 402 +7111 403 +7112 403 +7113 402 +7114 403 +7115 403 +7116 402 +7117 403 +7118 403 +7119 402 +7120 403 +7121 403 +7122 402 +7123 403 +7124 403 +7125 402 +7126 403 +7127 403 +7128 402 +7129 403 +7130 403 +7131 402 +7132 403 +7133 403 +7134 402 +7135 403 +7136 403 +7137 402 +7138 403 +7139 403 +7140 402 +7141 403 +7142 403 +7143 402 +7144 403 +7145 403 +7146 402 +7147 403 +7148 403 +7149 402 +7150 403 +7151 403 +7152 402 +7153 403 +7154 403 +7155 402 +7156 403 +7157 403 +7158 402 +7159 403 +7160 403 +7161 402 +7162 403 +7163 403 +7164 402 +7165 403 +7166 403 +7167 402 +7168 403 +7169 403 +7170 402 +7171 403 +7172 403 +7173 402 +7174 403 +7175 403 +7176 402 +7177 403 +7178 403 +7179 402 +7180 403 +7181 403 +7182 402 +7183 403 +7184 403 +7185 402 +7186 403 +7187 403 +7188 402 +7189 403 +7190 403 +7191 402 +7192 403 +7193 403 +7194 402 +7195 403 +7196 403 +7197 402 +7198 403 +7199 403 +7200 402 +7201 403 +7202 403 +7203 402 +7204 403 +7205 403 +7206 402 +7207 403 +7208 403 +7209 402 +7210 403 +7211 403 +7212 402 +7213 403 +7214 403 +7215 402 +7216 403 +7217 403 +7218 402 +7219 403 +7220 403 +7221 402 +7222 403 +7223 403 +7224 402 +7225 403 +7226 403 +7227 402 +7228 403 +7229 403 +7230 402 +7231 403 +7232 403 +7233 402 +7234 403 +7235 403 +7236 402 +7237 403 +7238 403 +7239 402 +7240 403 +7241 403 +7242 402 +7243 403 +7244 403 +7245 402 +7246 403 +7247 403 +7248 402 +7249 403 +7250 403 +7251 402 +7252 403 +7253 403 +7254 402 +7255 403 +7256 403 +7257 402 +7258 403 +7259 403 +7260 402 +7261 403 +7262 403 +7263 402 +7264 403 +7265 403 +7266 402 +7267 403 +7268 403 +7269 402 +7270 403 +7271 403 +7272 402 +7273 403 +7274 403 +7275 402 +7276 403 +7277 403 +7278 402 +7279 403 +7280 403 +7281 402 +7282 403 +7283 403 +7284 402 +7285 403 +7286 403 +7287 402 +7288 403 +7289 403 +7290 402 +7291 403 +7292 403 +7293 402 +7294 403 +7295 403 +7296 402 +7297 403 +7298 403 +7299 402 +7300 403 +7301 403 +7302 402 +7303 403 +7304 403 +7305 402 +7306 403 +7307 403 +7308 402 +7309 403 +7310 403 +7311 402 +7312 403 +7313 403 +7314 402 +7315 403 +7316 403 +7317 402 +7318 403 +7319 403 +7320 402 +7321 403 +7322 403 +7323 402 +7324 403 +7325 403 +7326 402 +7327 403 +7328 403 +7329 402 +7330 403 +7331 403 +7332 402 +7333 403 +7334 403 +7335 402 +7336 403 +7337 403 +7338 402 +7339 403 +7340 403 +7341 402 +7342 403 +7343 403 +7344 402 +7345 403 +7346 403 +7347 402 +7348 403 +7349 403 +7350 402 +7351 403 +7352 403 +7353 402 +7354 403 +7355 403 +7356 402 +7357 403 +7358 403 +7359 402 +7360 403 +7361 403 +7362 402 +7363 403 +7364 403 +7365 402 +7366 403 +7367 403 +7368 402 +7369 403 +7370 403 +7371 402 +7372 403 +7373 403 +7374 402 +7375 403 +7376 403 +7377 402 +7378 403 +7379 403 +7380 402 +7381 403 +7382 403 +7383 402 +7384 403 +7385 403 +7386 402 +7387 403 +7388 403 +7389 402 +7390 403 +7391 403 +7392 402 +7393 403 +7394 403 +7395 402 +7396 403 +7397 403 +7398 402 +7399 403 +7400 403 +7401 402 +7402 403 +7403 403 +7404 402 +7405 403 +7406 403 +7407 402 +7408 403 +7409 403 +7410 402 +7411 403 +7412 403 +7413 402 +7414 403 +7415 403 +7416 402 +7417 403 +7418 403 +7419 402 +7420 403 +7421 403 +7422 402 +7423 403 +7424 403 +7425 402 +7426 403 +7427 403 +7428 402 +7429 403 +7430 403 +7431 402 +7432 403 +7433 403 +7434 402 +7435 403 +7436 403 +7437 402 +7438 403 +7439 403 +7440 402 +7441 403 +7442 403 +7443 402 +7444 403 +7445 403 +7446 402 +7447 403 +7448 403 +7449 402 +7450 403 +7451 403 +7452 402 +7453 403 +7454 403 +7455 402 +7456 403 +7457 403 +7458 402 +7459 403 +7460 403 +7461 402 +7462 403 +7463 403 +7464 402 +7465 403 +7466 403 +7467 402 +7468 403 +7469 403 +7470 402 +7471 403 +7472 403 +7473 402 +7474 403 +7475 403 +7476 402 +7477 403 +7478 403 +7479 402 +7480 403 +7481 403 +7482 402 +7483 403 +7484 403 +7485 402 +7486 403 +7487 403 +7488 402 +7489 403 +7490 403 +7491 402 +7492 403 +7493 403 +7494 402 +7495 403 +7496 403 +7497 402 +7498 403 +7499 403 +7500 402 +7501 403 +7502 403 +7503 402 +7504 403 +7505 403 +7506 402 +7507 403 +7508 403 +7509 402 +7510 403 +7511 403 +7512 402 +7513 403 +7514 403 +7515 402 +7516 403 +7517 403 +7518 402 +7519 403 +7520 403 +7521 402 +7522 403 +7523 403 +7524 402 +7525 403 +7526 403 +7527 402 +7528 403 +7529 403 +7530 402 +7531 403 +7532 403 +7533 402 +7534 403 +7535 403 +7536 402 +7537 403 +7538 403 +7539 402 +7540 403 +7541 403 +7542 402 +7543 403 +7544 403 +7545 402 +7546 403 +7547 403 +7548 402 +7549 403 +7550 403 +7551 402 +7552 403 +7553 403 +7554 402 +7555 403 +7556 403 +7557 402 +7558 403 +7559 403 +7560 402 +7561 403 +7562 403 +7563 402 +7564 403 +7565 403 +7566 402 +7567 403 +7568 403 +7569 402 +7570 403 +7571 403 +7572 402 +7573 403 +7574 403 +7575 402 +7576 403 +7577 403 +7578 402 +7579 403 +7580 403 +7581 402 +7582 403 +7583 403 +7584 402 +7585 403 +7586 403 +7587 402 +7588 403 +7589 403 +7590 402 +7591 403 +7592 403 +7593 402 +7594 403 +7595 403 +7596 402 +7597 403 +7598 403 +7599 402 +7600 403 +7601 403 +7602 402 +7603 403 +7604 403 +7605 402 +7606 403 +7607 403 +7608 402 +7609 403 +7610 403 +7611 402 +7612 403 +7613 403 +7614 402 +7615 403 +7616 403 +7617 402 +7618 403 +7619 403 +7620 402 +7621 403 +7622 403 +7623 402 +7624 403 +7625 403 +7626 402 +7627 403 +7628 403 +7629 402 +7630 403 +7631 403 +7632 402 +7633 403 +7634 403 +7635 402 +7636 403 +7637 403 +7638 402 +7639 403 +7640 403 +7641 402 +7642 403 +7643 403 +7644 402 +7645 403 +7646 403 +7647 402 +7648 403 +7649 403 +7650 402 +7651 403 +7652 403 +7653 402 +7654 403 +7655 403 +7656 402 +7657 403 +7658 403 +7659 402 +7660 403 +7661 403 +7662 402 +7663 403 +7664 403 +7665 402 +7666 403 +7667 403 +7668 402 +7669 403 +7670 403 +7671 402 +7672 403 +7673 403 +7674 402 +7675 403 +7676 403 +7677 402 +7678 403 +7679 403 +7680 402 +7681 403 +7682 403 +7683 402 +7684 403 +7685 403 +7686 402 +7687 403 +7688 403 +7689 402 +7690 403 +7691 403 +7692 402 +7693 403 +7694 403 +7695 402 +7696 403 +7697 403 +7698 402 +7699 403 +7700 403 +7701 402 +7702 403 +7703 403 +7704 402 +7705 403 +7706 403 +7707 402 +7708 403 +7709 403 +7710 402 +7711 403 +7712 403 +7713 402 +7714 403 +7715 403 +7716 402 +7717 403 +7718 403 +7719 402 +7720 403 +7721 403 +7722 402 +7723 403 +7724 403 +7725 402 +7726 403 +7727 403 +7728 402 +7729 403 +7730 403 +7731 402 +7732 403 +7733 403 +7734 402 +7735 403 +7736 403 +7737 402 +7738 403 +7739 403 +7740 402 +7741 403 +7742 403 +7743 402 +7744 403 +7745 403 +7746 402 +7747 403 +7748 403 +7749 402 +7750 403 +7751 403 +7752 402 +7753 403 +7754 403 +7755 402 +7756 403 +7757 403 +7758 402 +7759 403 +7760 403 +7761 402 +7762 403 +7763 403 +7764 402 +7765 403 +7766 403 +7767 402 +7768 403 +7769 403 +7770 402 +7771 403 +7772 403 +7773 402 +7774 403 +7775 403 +7776 402 +7777 403 +7778 403 +7779 402 +7780 403 +7781 403 +7782 402 +7783 403 +7784 403 +7785 402 +7786 403 +7787 403 +7788 402 +7789 403 +7790 403 +7791 402 +7792 403 +7793 403 +7794 402 +7795 403 +7796 403 +7797 402 +7798 403 +7799 403 +7800 402 +7801 403 +7802 403 +7803 402 +7804 403 +7805 403 +7806 402 +7807 403 +7808 403 +7809 402 +7810 403 +7811 403 +7812 402 +7813 403 +7814 403 +7815 402 +7816 403 +7817 403 +7818 402 +7819 403 +7820 403 +7821 402 +7822 403 +7823 403 +7824 402 +7825 403 +7826 403 +7827 402 +7828 403 +7829 403 +7830 402 +7831 403 +7832 403 +7833 402 +7834 403 +7835 403 +7836 402 +7837 403 +7838 403 +7839 402 +7840 403 +7841 403 +7842 402 +7843 403 +7844 403 +7845 402 +7846 403 +7847 403 +7848 402 +7849 403 +7850 403 +7851 402 +7852 403 +7853 403 +7854 402 +7855 403 +7856 403 +7857 402 +7858 403 +7859 403 +7860 402 +7861 403 +7862 403 +7863 402 +7864 403 +7865 403 +7866 402 +7867 403 +7868 403 +7869 402 +7870 403 +7871 403 +7872 402 +7873 403 +7874 403 +7875 402 +7876 403 +7877 403 +7878 402 +7879 403 +7880 403 +7881 402 +7882 403 +7883 403 +7884 402 +7885 403 +7886 403 +7887 402 +7888 403 +7889 403 +7890 402 +7891 403 +7892 403 +7893 402 +7894 403 +7895 403 +7896 402 +7897 403 +7898 403 +7899 402 +7900 403 +7901 403 +7902 402 +7903 403 +7904 403 +7905 402 +7906 403 +7907 403 +7908 402 +7909 403 +7910 403 +7911 402 +7912 403 +7913 403 +7914 402 +7915 403 +7916 403 +7917 402 +7918 403 +7919 403 +7920 402 +7921 403 +7922 403 +7923 402 +7924 403 +7925 403 +7926 402 +7927 403 +7928 403 +7929 402 +7930 403 +7931 403 +7932 402 +7933 403 +7934 403 +7935 402 +7936 403 +7937 403 +7938 402 +7939 403 +7940 403 +7941 402 +7942 403 +7943 403 +7944 402 +7945 403 +7946 403 +7947 402 +7948 403 +7949 403 +7950 402 +7951 403 +7952 403 +7953 402 +7954 403 +7955 403 +7956 402 +7957 403 +7958 403 +7959 402 +7960 403 +7961 403 +7962 402 +7963 403 +7964 403 +7965 402 +7966 403 +7967 403 +7968 402 +7969 403 +7970 403 +7971 402 +7972 403 +7973 403 +7974 402 +7975 403 +7976 403 +7977 402 +7978 403 +7979 403 +7980 402 +7981 403 +7982 403 +7983 402 +7984 403 +7985 403 +7986 402 +7987 403 +7988 403 +7989 402 +7990 403 +7991 403 +7992 402 +7993 403 +7994 403 +7995 402 +7996 403 +7997 403 +7998 402 +7999 403 +8000 403 +8001 402 +8002 403 +8003 403 +8004 402 +8005 403 +8006 403 +8007 402 +8008 403 +8009 403 +8010 402 +8011 403 +8012 403 +8013 402 +8014 403 +8015 403 +8016 402 +8017 403 +8018 403 +8019 402 +8020 403 +8021 403 +8022 402 +8023 403 +8024 403 +8025 402 +8026 403 +8027 403 +8028 402 +8029 403 +8030 403 +8031 402 +8032 403 +8033 403 +8034 402 +8035 403 +8036 403 +8037 402 +8038 403 +8039 403 +8040 402 +8041 403 +8042 403 +8043 402 +8044 403 +8045 403 +8046 402 +8047 403 +8048 403 +8049 402 +8050 403 +8051 403 +8052 402 +8053 403 +8054 403 +8055 402 +8056 403 +8057 403 +8058 402 +8059 403 +8060 403 +8061 402 +8062 403 +8063 403 +8064 402 +8065 403 +8066 403 +8067 402 +8068 403 +8069 403 +8070 402 +8071 403 +8072 403 +8073 402 +8074 403 +8075 403 +8076 402 +8077 403 +8078 403 +8079 402 +8080 403 +8081 403 +8082 402 +8083 403 +8084 403 +8085 402 +8086 403 +8087 403 +8088 402 +8089 403 +8090 403 +8091 402 +8092 403 +8093 403 +8094 402 +8095 403 +8096 403 +8097 402 +8098 403 +8099 403 +8100 402 +8101 403 +8102 403 +8103 402 +8104 403 +8105 403 +8106 402 +8107 403 +8108 403 +8109 402 +8110 403 +8111 403 +8112 402 +8113 403 +8114 403 +8115 402 +8116 403 +8117 403 +8118 402 +8119 403 +8120 403 +8121 402 +8122 403 +8123 403 +8124 402 +8125 403 +8126 403 +8127 402 +8128 403 +8129 403 +8130 402 +8131 403 +8132 403 +8133 402 +8134 403 +8135 403 +8136 402 +8137 403 +8138 403 +8139 402 +8140 403 +8141 403 +8142 402 +8143 403 +8144 403 +8145 402 +8146 403 +8147 403 +8148 402 +8149 403 +8150 403 +8151 402 +8152 403 +8153 403 +8154 402 +8155 403 +8156 403 +8157 402 +8158 403 +8159 403 +8160 402 +8161 403 +8162 403 +8163 402 +8164 403 +8165 403 +8166 402 +8167 403 +8168 403 +8169 402 +8170 403 +8171 403 +8172 402 +8173 403 +8174 403 +8175 402 +8176 403 +8177 403 +8178 402 +8179 403 +8180 403 +8181 402 +8182 403 +8183 403 +8184 402 +8185 403 +8186 403 +8187 402 +8188 403 +8189 403 +8190 402 +8191 403 +8192 403 +8193 402 +8194 403 +8195 403 +8196 402 +8197 403 +8198 403 +8199 402 +8200 403 +8201 403 +8202 402 +8203 403 +8204 403 +8205 402 +8206 403 +8207 403 +8208 402 +8209 403 +8210 403 +8211 402 +8212 403 +8213 403 +8214 402 +8215 403 +8216 403 +8217 402 +8218 403 +8219 403 +8220 402 +8221 403 +8222 403 +8223 402 +8224 403 +8225 403 +8226 402 +8227 403 +8228 403 +8229 402 +8230 403 +8231 403 +8232 402 +8233 403 +8234 403 +8235 402 +8236 403 +8237 403 +8238 402 +8239 403 +8240 403 +8241 402 +8242 403 +8243 403 +8244 402 +8245 403 +8246 403 +8247 402 +8248 403 +8249 403 +8250 402 +8251 403 +8252 403 +8253 402 +8254 403 +8255 403 +8256 402 +8257 403 +8258 403 +8259 402 +8260 403 +8261 403 +8262 402 +8263 403 +8264 403 +8265 402 +8266 403 +8267 403 +8268 402 +8269 403 +8270 403 +8271 402 +8272 403 +8273 403 +8274 402 +8275 403 +8276 403 +8277 402 +8278 403 +8279 403 +8280 402 +8281 403 +8282 403 +8283 402 +8284 403 +8285 403 +8286 402 +8287 403 +8288 403 +8289 402 +8290 403 +8291 403 +8292 402 +8293 403 +8294 403 +8295 402 +8296 403 +8297 403 +8298 402 +8299 403 +8300 403 +8301 402 +8302 403 +8303 403 +8304 402 +8305 403 +8306 403 +8307 402 +8308 403 +8309 403 +8310 402 +8311 403 +8312 403 +8313 402 +8314 403 +8315 403 +8316 402 +8317 403 +8318 403 +8319 402 +8320 403 +8321 403 +8322 402 +8323 403 +8324 403 +8325 402 +8326 403 +8327 403 +8328 402 +8329 403 +8330 403 +8331 402 +8332 403 +8333 403 +8334 402 +8335 403 +8336 403 +8337 402 +8338 403 +8339 403 +8340 402 +8341 403 +8342 403 +8343 402 +8344 403 +8345 403 +8346 402 +8347 403 +8348 403 +8349 402 +8350 403 +8351 403 +8352 402 +8353 403 +8354 403 +8355 402 +8356 403 +8357 403 +8358 402 +8359 403 +8360 403 +8361 402 +8362 403 +8363 403 +8364 402 +8365 403 +8366 403 +8367 402 +8368 403 +8369 403 +8370 402 +8371 403 +8372 403 +8373 402 +8374 403 +8375 403 +8376 402 +8377 403 +8378 403 +8379 402 +8380 403 +8381 403 +8382 402 +8383 403 +8384 403 +8385 402 +8386 403 +8387 403 +8388 402 +8389 403 +8390 403 +8391 402 +8392 403 +8393 403 +8394 402 +8395 403 +8396 403 +8397 402 +8398 403 +8399 403 +8400 402 +8401 403 +8402 403 +8403 402 +8404 403 +8405 403 +8406 402 +8407 403 +8408 403 +8409 402 +8410 403 +8411 403 +8412 402 +8413 403 +8414 403 +8415 402 +8416 403 +8417 403 +8418 402 +8419 403 +8420 403 +8421 402 +8422 403 +8423 403 +8424 402 +8425 403 +8426 403 +8427 402 +8428 403 +8429 403 +8430 402 +8431 403 +8432 403 +8433 402 +8434 403 +8435 403 +8436 402 +8437 403 +8438 403 +8439 402 +8440 403 +8441 403 +8442 402 +8443 403 +8444 403 +8445 402 +8446 403 +8447 403 +8448 402 +8449 403 +8450 403 +8451 402 +8452 403 +8453 403 +8454 402 +8455 403 +8456 403 +8457 402 +8458 403 +8459 403 +8460 402 +8461 403 +8462 403 +8463 402 +8464 403 +8465 403 +8466 402 +8467 403 +8468 403 +8469 402 +8470 403 +8471 403 +8472 402 +8473 403 +8474 403 +8475 402 +8476 403 +8477 403 +8478 402 +8479 403 +8480 403 +8481 402 +8482 403 +8483 403 +8484 402 +8485 403 +8486 403 +8487 402 +8488 403 +8489 403 +8490 402 +8491 403 +8492 403 +8493 402 +8494 403 +8495 403 +8496 402 +8497 403 +8498 403 +8499 402 +8500 403 +8501 403 +8502 402 +8503 403 +8504 403 +8505 402 +8506 403 +8507 403 +8508 402 +8509 403 +8510 403 +8511 402 +8512 403 +8513 403 +8514 402 +8515 403 +8516 403 +8517 402 +8518 403 +8519 403 +8520 402 +8521 403 +8522 403 +8523 402 +8524 403 +8525 403 +8526 402 +8527 403 +8528 403 +8529 402 +8530 403 +8531 403 +8532 402 +8533 403 +8534 403 +8535 402 +8536 403 +8537 403 +8538 402 +8539 403 +8540 403 +8541 402 +8542 403 +8543 403 +8544 402 +8545 403 +8546 403 +8547 402 +8548 403 +8549 403 +8550 402 +8551 403 +8552 403 +8553 402 +8554 403 +8555 403 +8556 402 +8557 403 +8558 403 +8559 402 +8560 403 +8561 403 +8562 402 +8563 403 +8564 403 +8565 402 +8566 403 +8567 403 +8568 402 +8569 403 +8570 403 +8571 402 +8572 403 +8573 403 +8574 402 +8575 403 +8576 403 +8577 402 +8578 403 +8579 403 +8580 402 +8581 403 +8582 403 +8583 402 +8584 403 +8585 403 +8586 402 +8587 403 +8588 403 +8589 402 +8590 403 +8591 403 +8592 402 +8593 403 +8594 403 +8595 402 +8596 403 +8597 403 +8598 402 +8599 403 +8600 403 +8601 402 +8602 403 +8603 403 +8604 402 +8605 403 +8606 403 +8607 402 +8608 403 +8609 403 +8610 402 +8611 403 +8612 403 +8613 402 +8614 403 +8615 403 +8616 402 +8617 403 +8618 403 +8619 402 +8620 403 +8621 403 +8622 402 +8623 403 +8624 403 +8625 402 +8626 403 +8627 403 +8628 402 +8629 403 +8630 403 +8631 402 +8632 403 +8633 403 +8634 402 +8635 403 +8636 403 +8637 402 +8638 403 +8639 403 +8640 402 +8641 403 +8642 403 +8643 402 +8644 403 +8645 403 +8646 402 +8647 403 +8648 403 +8649 402 +8650 403 +8651 403 +8652 402 +8653 403 +8654 403 +8655 402 +8656 403 +8657 403 +8658 402 +8659 403 +8660 403 +8661 402 +8662 403 +8663 403 +8664 402 +8665 403 +8666 403 +8667 402 +8668 403 +8669 403 +8670 402 +8671 403 +8672 403 +8673 402 +8674 403 +8675 403 +8676 402 +8677 403 +8678 403 +8679 402 +8680 403 +8681 403 +8682 402 +8683 403 +8684 403 +8685 402 +8686 403 +8687 403 +8688 402 +8689 403 +8690 403 +8691 402 +8692 403 +8693 403 +8694 402 +8695 403 +8696 403 +8697 402 +8698 403 +8699 403 +8700 402 +8701 403 +8702 403 +8703 402 +8704 403 +8705 403 +8706 402 +8707 403 +8708 403 +8709 402 +8710 403 +8711 403 +8712 402 +8713 403 +8714 403 +8715 402 +8716 403 +8717 403 +8718 402 +8719 403 +8720 403 +8721 402 +8722 403 +8723 403 +8724 402 +8725 403 +8726 403 +8727 402 +8728 403 +8729 403 +8730 402 +8731 403 +8732 403 +8733 402 +8734 403 +8735 403 +8736 402 +8737 403 +8738 403 +8739 402 +8740 403 +8741 403 +8742 402 +8743 403 +8744 403 +8745 402 +8746 403 +8747 403 +8748 402 +8749 403 +8750 403 +8751 402 +8752 403 +8753 403 +8754 402 +8755 403 +8756 403 +8757 402 +8758 403 +8759 403 +8760 402 +8761 403 +8762 403 +8763 402 +8764 403 +8765 403 +8766 402 +8767 403 +8768 403 +8769 402 +8770 403 +8771 403 +8772 402 +8773 403 +8774 403 +8775 402 +8776 403 +8777 403 +8778 402 +8779 403 +8780 403 +8781 402 +8782 403 +8783 403 +8784 402 +8785 403 +8786 403 +8787 402 +8788 403 +8789 403 +8790 402 +8791 403 +8792 403 +8793 402 +8794 403 +8795 403 +8796 402 +8797 403 +8798 403 +8799 402 +8800 403 +8801 403 +8802 402 +8803 403 +8804 403 +8805 402 +8806 403 +8807 403 +8808 402 +8809 403 +8810 403 +8811 402 +8812 403 +8813 403 +8814 402 +8815 403 +8816 403 +8817 402 +8818 403 +8819 403 +8820 402 +8821 403 +8822 403 +8823 402 +8824 403 +8825 403 +8826 402 +8827 403 +8828 403 +8829 402 +8830 403 +8831 403 +8832 402 +8833 403 +8834 403 +8835 402 +8836 403 +8837 403 +8838 402 +8839 403 +8840 403 +8841 402 +8842 403 +8843 403 +8844 402 +8845 403 +8846 403 +8847 402 +8848 403 +8849 403 +8850 402 +8851 403 +8852 403 +8853 402 +8854 403 +8855 403 +8856 402 +8857 403 +8858 403 +8859 402 +8860 403 +8861 403 +8862 402 +8863 403 +8864 403 +8865 402 +8866 403 +8867 403 +8868 402 +8869 403 +8870 403 +8871 402 +8872 403 +8873 403 +8874 402 +8875 403 +8876 403 +8877 402 +8878 403 +8879 403 +8880 402 +8881 403 +8882 403 +8883 402 +8884 403 +8885 403 +8886 402 +8887 403 +8888 403 +8889 402 +8890 403 +8891 403 +8892 402 +8893 403 +8894 403 +8895 402 +8896 403 +8897 403 +8898 402 +8899 403 +8900 403 +8901 402 +8902 403 +8903 403 +8904 402 +8905 403 +8906 403 +8907 402 +8908 403 +8909 403 +8910 402 +8911 403 +8912 403 +8913 402 +8914 403 +8915 403 +8916 402 +8917 403 +8918 403 +8919 402 +8920 403 +8921 403 +8922 402 +8923 403 +8924 403 +8925 402 +8926 403 +8927 403 +8928 402 +8929 403 +8930 403 +8931 402 +8932 403 +8933 403 +8934 402 +8935 403 +8936 403 +8937 402 +8938 403 +8939 403 +8940 402 +8941 403 +8942 403 +8943 402 +8944 403 +8945 403 +8946 402 +8947 403 +8948 403 +8949 402 +8950 403 +8951 403 +8952 402 +8953 403 +8954 403 +8955 402 +8956 403 +8957 403 +8958 402 +8959 403 +8960 403 +8961 402 +8962 403 +8963 403 +8964 402 +8965 403 +8966 403 +8967 402 +8968 403 +8969 403 +8970 402 +8971 403 +8972 403 +8973 402 +8974 403 +8975 403 +8976 402 +8977 403 +8978 403 +8979 402 +8980 403 +8981 403 +8982 402 +8983 403 +8984 403 +8985 402 +8986 403 +8987 403 +8988 402 +8989 403 +8990 403 +8991 402 +8992 403 +8993 403 +8994 402 +8995 403 +8996 403 +8997 402 +8998 403 +8999 403 +9000 402 +9001 403 +9002 403 +9003 402 +9004 403 +9005 403 +9006 402 +9007 403 +9008 403 +9009 402 +9010 403 +9011 403 +9012 402 +9013 403 +9014 403 +9015 402 +9016 403 +9017 403 +9018 402 +9019 403 +9020 403 +9021 402 +9022 403 +9023 403 +9024 402 +9025 403 +9026 403 +9027 402 +9028 403 +9029 403 +9030 402 +9031 403 +9032 403 +9033 402 +9034 403 +9035 403 +9036 402 +9037 403 +9038 403 +9039 402 +9040 403 +9041 403 +9042 402 +9043 403 +9044 403 +9045 402 +9046 403 +9047 403 +9048 402 +9049 403 +9050 403 +9051 402 +9052 403 +9053 403 +9054 402 +9055 403 +9056 403 +9057 402 +9058 403 +9059 403 +9060 402 +9061 403 +9062 403 +9063 402 +9064 403 +9065 403 +9066 402 +9067 403 +9068 403 +9069 402 +9070 403 +9071 403 +9072 402 +9073 403 +9074 403 +9075 402 +9076 403 +9077 403 +9078 402 +9079 403 +9080 403 +9081 402 +9082 403 +9083 403 +9084 402 +9085 403 +9086 403 +9087 402 +9088 403 +9089 403 +9090 402 +9091 403 +9092 403 +9093 402 +9094 403 +9095 403 +9096 402 +9097 403 +9098 403 +9099 402 +9100 403 +9101 403 +9102 402 +9103 403 +9104 403 +9105 402 +9106 403 +9107 403 +9108 402 +9109 403 +9110 403 +9111 402 +9112 403 +9113 403 +9114 402 +9115 403 +9116 403 +9117 402 +9118 403 +9119 403 +9120 402 +9121 403 +9122 403 +9123 402 +9124 403 +9125 403 +9126 402 +9127 403 +9128 403 +9129 402 +9130 403 +9131 403 +9132 402 +9133 403 +9134 403 +9135 402 +9136 403 +9137 403 +9138 402 +9139 403 +9140 403 +9141 402 +9142 403 +9143 403 +9144 402 +9145 403 +9146 403 +9147 402 +9148 403 +9149 403 +9150 402 +9151 403 +9152 403 +9153 402 +9154 403 +9155 403 +9156 402 +9157 403 +9158 403 +9159 402 +9160 403 +9161 403 +9162 402 +9163 403 +9164 403 +9165 402 +9166 403 +9167 403 +9168 402 +9169 403 +9170 403 +9171 402 +9172 403 +9173 403 +9174 402 +9175 403 +9176 403 +9177 402 +9178 403 +9179 403 +9180 402 +9181 403 +9182 403 +9183 402 +9184 403 +9185 403 +9186 402 +9187 403 +9188 403 +9189 402 +9190 403 +9191 403 +9192 402 +9193 403 +9194 403 +9195 402 +9196 403 +9197 403 +9198 402 +9199 403 +9200 403 +9201 402 +9202 403 +9203 403 +9204 402 +9205 403 +9206 403 +9207 402 +9208 403 +9209 403 +9210 402 +9211 403 +9212 403 +9213 402 +9214 403 +9215 403 +9216 402 +9217 403 +9218 403 +9219 402 +9220 403 +9221 403 +9222 402 +9223 403 +9224 403 +9225 402 +9226 403 +9227 403 +9228 402 +9229 403 +9230 403 +9231 402 +9232 403 +9233 403 +9234 402 +9235 403 +9236 403 +9237 402 +9238 403 +9239 403 +9240 402 +9241 403 +9242 403 +9243 402 +9244 403 +9245 403 +9246 402 +9247 403 +9248 403 +9249 402 +9250 403 +9251 403 +9252 402 +9253 403 +9254 403 +9255 402 +9256 403 +9257 403 +9258 402 +9259 403 +9260 403 +9261 402 +9262 403 +9263 403 +9264 402 +9265 403 +9266 403 +9267 402 +9268 403 +9269 403 +9270 402 +9271 403 +9272 403 +9273 402 +9274 403 +9275 403 +9276 402 +9277 403 +9278 403 +9279 402 +9280 403 +9281 403 +9282 402 +9283 403 +9284 403 +9285 402 +9286 403 +9287 403 +9288 402 +9289 403 +9290 403 +9291 402 +9292 403 +9293 403 +9294 402 +9295 403 +9296 403 +9297 402 +9298 403 +9299 403 +9300 402 +9301 403 +9302 403 +9303 402 +9304 403 +9305 403 +9306 402 +9307 403 +9308 403 +9309 402 +9310 403 +9311 403 +9312 402 +9313 403 +9314 403 +9315 402 +9316 403 +9317 403 +9318 402 +9319 403 +9320 403 +9321 402 +9322 403 +9323 403 +9324 402 +9325 403 +9326 403 +9327 402 +9328 403 +9329 403 +9330 402 +9331 403 +9332 403 +9333 402 +9334 403 +9335 403 +9336 402 +9337 403 +9338 403 +9339 402 +9340 403 +9341 403 +9342 402 +9343 403 +9344 403 +9345 402 +9346 403 +9347 403 +9348 402 +9349 403 +9350 403 +9351 402 +9352 403 +9353 403 +9354 402 +9355 403 +9356 403 +9357 402 +9358 403 +9359 403 +9360 402 +9361 403 +9362 403 +9363 402 +9364 403 +9365 403 +9366 402 +9367 403 +9368 403 +9369 402 +9370 403 +9371 403 +9372 402 +9373 403 +9374 403 +9375 402 +9376 403 +9377 403 +9378 402 +9379 403 +9380 403 +9381 402 +9382 403 +9383 403 +9384 402 +9385 403 +9386 403 +9387 402 +9388 403 +9389 403 +9390 402 +9391 403 +9392 403 +9393 402 +9394 403 +9395 403 +9396 402 +9397 403 +9398 403 +9399 402 +9400 403 +9401 403 +9402 402 +9403 403 +9404 403 +9405 402 +9406 403 +9407 403 +9408 402 +9409 403 +9410 403 +9411 402 +9412 403 +9413 403 +9414 402 +9415 403 +9416 403 +9417 402 +9418 403 +9419 403 +9420 402 +9421 403 +9422 403 +9423 402 +9424 403 +9425 403 +9426 402 +9427 403 +9428 403 +9429 402 +9430 403 +9431 403 +9432 402 +9433 403 +9434 403 +9435 402 +9436 403 +9437 403 +9438 402 +9439 403 +9440 403 +9441 402 +9442 403 +9443 403 +9444 402 +9445 403 +9446 403 +9447 402 +9448 403 +9449 403 +9450 402 +9451 403 +9452 403 +9453 402 +9454 403 +9455 403 +9456 402 +9457 403 +9458 403 +9459 402 +9460 403 +9461 403 +9462 402 +9463 403 +9464 403 +9465 402 +9466 403 +9467 403 +9468 402 +9469 403 +9470 403 +9471 402 +9472 403 +9473 403 +9474 402 +9475 403 +9476 403 +9477 402 +9478 403 +9479 403 +9480 402 +9481 403 +9482 403 +9483 402 +9484 403 +9485 403 +9486 402 +9487 403 +9488 403 +9489 402 +9490 403 +9491 403 +9492 402 +9493 403 +9494 403 +9495 402 +9496 403 +9497 403 +9498 402 +9499 403 +9500 403 +9501 402 +9502 403 +9503 403 +9504 402 +9505 403 +9506 403 +9507 402 +9508 403 +9509 403 +9510 402 +9511 403 +9512 403 +9513 402 +9514 403 +9515 403 +9516 402 +9517 403 +9518 403 +9519 402 +9520 403 +9521 403 +9522 402 +9523 403 +9524 403 +9525 402 +9526 403 +9527 403 +9528 402 +9529 403 +9530 403 +9531 402 +9532 403 +9533 403 +9534 402 +9535 403 +9536 403 +9537 402 +9538 403 +9539 403 +9540 402 +9541 403 +9542 403 +9543 402 +9544 403 +9545 403 +9546 402 +9547 403 +9548 403 +9549 402 +9550 403 +9551 403 +9552 402 +9553 403 +9554 403 +9555 402 +9556 403 +9557 403 +9558 402 +9559 403 +9560 403 +9561 402 +9562 403 +9563 403 +9564 402 +9565 403 +9566 403 +9567 402 +9568 403 +9569 403 +9570 402 +9571 403 +9572 403 +9573 402 +9574 403 +9575 403 +9576 402 +9577 403 +9578 403 +9579 402 +9580 403 +9581 403 +9582 402 +9583 403 +9584 403 +9585 402 +9586 403 +9587 403 +9588 402 +9589 403 +9590 403 +9591 402 +9592 403 +9593 403 +9594 402 +9595 403 +9596 403 +9597 402 +9598 403 +9599 403 +9600 402 +9601 403 +9602 403 +9603 402 +9604 403 +9605 403 +9606 402 +9607 403 +9608 403 +9609 402 +9610 403 +9611 403 +9612 402 +9613 403 +9614 403 +9615 402 +9616 403 +9617 403 +9618 402 +9619 403 +9620 403 +9621 402 +9622 403 +9623 403 +9624 402 +9625 403 +9626 403 +9627 402 +9628 403 +9629 403 +9630 402 +9631 403 +9632 403 +9633 402 +9634 403 +9635 403 +9636 402 +9637 403 +9638 403 +9639 402 +9640 403 +9641 403 +9642 402 +9643 403 +9644 403 +9645 402 +9646 403 +9647 403 +9648 402 +9649 403 +9650 403 +9651 402 +9652 403 +9653 403 +9654 402 +9655 403 +9656 403 +9657 402 +9658 403 +9659 403 +9660 402 +9661 403 +9662 403 +9663 402 +9664 403 +9665 403 +9666 402 +9667 403 +9668 403 +9669 402 +9670 403 +9671 403 +9672 402 +9673 403 +9674 403 +9675 402 +9676 403 +9677 403 +9678 402 +9679 403 +9680 403 +9681 402 +9682 403 +9683 403 +9684 402 +9685 403 +9686 403 +9687 402 +9688 403 +9689 403 +9690 402 +9691 403 +9692 403 +9693 402 +9694 403 +9695 403 +9696 402 +9697 403 +9698 403 +9699 402 +9700 403 +9701 403 +9702 402 +9703 403 +9704 403 +9705 402 +9706 403 +9707 403 +9708 402 +9709 403 +9710 403 +9711 402 +9712 403 +9713 403 +9714 402 +9715 403 +9716 403 +9717 402 +9718 403 +9719 403 +9720 402 +9721 403 +9722 403 +9723 402 +9724 403 +9725 403 +9726 402 +9727 403 +9728 403 +9729 402 +9730 403 +9731 403 +9732 402 +9733 403 +9734 403 +9735 402 +9736 403 +9737 403 diff --git a/src/AMOEBA/angle_amoeba.cpp b/src/AMOEBA/angle_amoeba.cpp index 9e29f1eee8..a578396d10 100644 --- a/src/AMOEBA/angle_amoeba.cpp +++ b/src/AMOEBA/angle_amoeba.cpp @@ -103,7 +103,9 @@ void AngleAmoeba::compute(int eflag, int vflag) ev_init(eflag,vflag); + // DEBUG int ubn = 0; + double eub = 0.0; for (n = 0; n < nanglelist; n++) { i1 = anglelist[n][0]; @@ -132,11 +134,12 @@ void AngleAmoeba::compute(int eflag, int vflag) if (uflag) { ubn++; - tinker_urey_bradley(i1,i3,type,eflag); + eub += tinker_urey_bradley(i1,i3,type,eflag); } } - printf("UB N %d\n",ubn); + // DEBUG + printf("UreyBradley n %d eng %g\n",ubn,eub); } /* ---------------------------------------------------------------------- */ @@ -540,7 +543,7 @@ void AngleAmoeba::tinker_bondangle(int i1, int i2, int i3, int type, int eflag) /* ---------------------------------------------------------------------- */ -void AngleAmoeba::tinker_urey_bradley(int i1, int i2, int type, int eflag) +double AngleAmoeba::tinker_urey_bradley(int i1, int i2, int type, int eflag) { double delx,dely,delz; double rsq,r,dr,rk; @@ -582,6 +585,8 @@ void AngleAmoeba::tinker_urey_bradley(int i1, int i2, int type, int eflag) } if (evflag) ev_tally2(i1,i2,nlocal,newton_bond,ebond,fbond,delx,dely,delz); + + return ebond; } /* ---------------------------------------------------------------------- */ diff --git a/src/AMOEBA/angle_amoeba.h b/src/AMOEBA/angle_amoeba.h index 69a782b48b..281f4a9adb 100644 --- a/src/AMOEBA/angle_amoeba.h +++ b/src/AMOEBA/angle_amoeba.h @@ -46,7 +46,7 @@ class AngleAmoeba : public Angle { void tinker_angle(int, int, int, int, int); void tinker_anglep(int, int, int, int, int); void tinker_bondangle(int, int, int, int, int); - void tinker_urey_bradley(int, int, int, int); + double tinker_urey_bradley(int, int, int, int); void allocate(); }; diff --git a/src/read_data.cpp b/src/read_data.cpp index c33c65f676..5b68f9d94e 100644 --- a/src/read_data.cpp +++ b/src/read_data.cpp @@ -658,6 +658,13 @@ void ReadData::command(int narg, char **arg) error->all(FLERR,"Must define angle_style before BondAngle Coeffs"); if (firstpass) anglecoeffs(2); else skip_lines(nangletypes); + } else if (strcmp(keyword,"UreyBradley Coeffs") == 0) { + if (atom->avec->angles_allow == 0) + error->all(FLERR,"Invalid data file section: UreyBradley Coeffs"); + if (force->angle == nullptr) + error->all(FLERR,"Must define angle_style before UreyBradley Coeffs"); + if (firstpass) anglecoeffs(3); + else skip_lines(nangletypes); } else if (strcmp(keyword,"MiddleBondTorsion Coeffs") == 0) { if (atom->avec->dihedrals_allow == 0) @@ -1852,6 +1859,7 @@ void ReadData::anglecoeffs(int which) if (which == 0) parse_coeffs(buf,nullptr,0,1,aoffset); else if (which == 1) parse_coeffs(buf,"bb",0,1,aoffset); else if (which == 2) parse_coeffs(buf,"ba",0,1,aoffset); + else if (which == 3) parse_coeffs(buf,"ub",0,1,aoffset); if (ncoeffarg == 0) error->all(FLERR,"Unexpected empty line in AngleCoeffs section"); force->angle->coeff(ncoeffarg,coeffarg); buf = next + 1; diff --git a/tools/tinker/data.py b/tools/tinker/data.py index 357450536b..40d6582814 100644 --- a/tools/tinker/data.py +++ b/tools/tinker/data.py @@ -250,6 +250,11 @@ class data: def write(self,file): f = open(file,"w") print >>f,self.title + + # write any keywords in standard list hkeywords + # in the order they are in hkeywords + # then write any extra keywords at end of header section + for keyword in hkeywords: if self.headers.has_key(keyword): if keyword == "xlo xhi" or keyword == "ylo yhi" or \ @@ -261,12 +266,30 @@ class data: print >>f,triple[0],triple[1],triple[2],keyword else: print >>f,self.headers[keyword],keyword + + for keyword in self.headers.keys(): + if keyword not in hkeywords: + print >>f,self.headers[keyword],keyword + + # write any sections in standard list skeywords + # in the order they are in skeywords + # then write any extra sections at end of file + for pair in skeywords: keyword = pair[0] if self.sections.has_key(keyword): print >>f,"\n%s\n" % keyword for line in self.sections[keyword]: print >>f,line, + + skeyfirst = [pair[0] for pair in skeywords] + + for keyword in self.sections.keys(): + if keyword not in skeyfirst: + print >>f,"\n%s\n" % keyword + for line in self.sections[keyword]: + print >>f,line, + f.close() # -------------------------------------------------------------------- @@ -348,35 +371,32 @@ class data: return self.headers["atom types"] # -------------------------------------------------------------------- -# data file keywords, both header and main sections +# standard data file keywords, both header and main sections hkeywords = ["atoms","ellipsoids","lines","triangles","bodies", - "bonds","angles","dihedrals","impropers","pitorsions", + "bonds","angles","dihedrals","impropers", "atom types","bond types","angle types","dihedral types", - "improper types","pitorsion types", + "improper types", "xlo xhi","ylo yhi","zlo zhi","xy xz yz"] skeywords = [["Masses","atom types"], ["Atoms","atoms"],["Ellipsoids","ellipsoids"], ["Lines","lines"],["Triangles","triangles"],["Bodies","bodies"], + ["Velocities","atoms"], ["Bonds","bonds"], ["Angles","angles"], ["Dihedrals","dihedrals"], ["Impropers","impropers"], - ["PiTorsions","pitorsions"], - ["Velocities","atoms"], ["Pair Coeffs","atom types"], - ["Bond Coeffs","bond types"],["Angle Coeffs","angle types"], + ["Bond Coeffs","bond types"], + ["Angle Coeffs","angle types"], ["Dihedral Coeffs","dihedral types"], ["Improper Coeffs","improper types"], - ["PiTorsion Coeffs","pitorsion types"], ["BondBond Coeffs","angle types"], ["BondAngle Coeffs","angle types"], - ["UreyBradley Coeffs","angle types"], ["MiddleBondTorsion Coeffs","dihedral types"], ["EndBondTorsion Coeffs","dihedral types"], ["AngleTorsion Coeffs","dihedral types"], ["AngleAngleTorsion Coeffs","dihedral types"], ["BondBond13 Coeffs","dihedral types"], - ["AngleAngle Coeffs","improper types"], - ["Molecules","atoms"]] + ["AngleAngle Coeffs","improper types"]] From bbe065e649c577d2c23ba4339c070ea4bea31c44 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Wed, 9 Mar 2022 15:37:19 -0700 Subject: [PATCH 081/585] initial version of fix pitorsion --- examples/amoeba/data.ubiquitin | 120 ++++++++++++++ examples/amoeba/in.ubiquitin | 9 +- src/AMOEBA/angle_amoeba.cpp | 17 +- src/AMOEBA/angle_amoeba.h | 2 +- src/AMOEBA/fix_pitorsion.cpp | 290 ++++++++++++++++++++------------- src/AMOEBA/fix_pitorsion.h | 3 +- src/modify.cpp | 2 +- src/read_data.cpp | 1 - tools/tinker/tinker2lmp.py | 39 +++-- 9 files changed, 326 insertions(+), 157 deletions(-) diff --git a/examples/amoeba/data.ubiquitin b/examples/amoeba/data.ubiquitin index a7b8684618..05a0673ce8 100644 --- a/examples/amoeba/data.ubiquitin +++ b/examples/amoeba/data.ubiquitin @@ -13,6 +13,8 @@ LAMMPS data file created from Tinker ubiquitin.xyz and amoeba_ubiquitin.prm file 0 54.99 xlo xhi 0 41.91 ylo yhi 0 41.91 zlo zhi +6 pitorsion types +106 pitorsions Masses @@ -26346,6 +26348,124 @@ UreyBradley Coeffs 110 0.0 0.0 111 -7.6 1.5537 +PiTorsions + +1 1 2 4 3 20 21 24 +2 1 21 23 22 37 38 41 +3 1 27 29 28 30 35 36 +4 1 38 40 39 56 57 60 +5 1 57 59 58 76 77 80 +6 2 62 65 63 64 66 71 +7 2 62 64 63 65 67 72 +8 2 63 71 64 66 68 73 +9 2 63 72 65 67 68 74 +10 2 64 73 66 68 67 75 +11 2 65 74 67 68 66 75 +12 1 77 79 78 92 93 96 +13 1 93 95 94 114 115 118 +14 1 115 117 116 128 129 132 +15 1 129 131 130 147 148 151 +16 1 148 150 149 161 162 165 +17 1 162 164 163 168 169 172 +18 1 169 171 170 190 191 194 +19 1 191 193 192 204 205 208 +20 1 205 207 206 223 224 227 +21 1 224 226 225 237 238 241 +22 1 238 240 239 256 257 260 +23 1 257 259 258 271 272 275 +24 1 272 274 273 287 288 291 +25 3 288 290 289 302 303 309 +26 1 303 305 304 316 317 320 +27 1 317 319 318 327 328 331 +28 1 328 330 329 339 340 343 +29 1 340 342 341 353 354 357 +30 1 354 356 355 372 373 376 +31 1 373 375 374 387 388 391 +32 1 388 390 389 401 402 405 +33 1 393 395 394 396 399 400 +34 1 402 404 403 417 418 421 +35 1 418 420 419 439 440 443 +36 1 440 442 441 449 450 453 +37 1 450 452 451 471 472 475 +38 1 472 474 473 490 491 494 +39 1 491 493 492 507 508 511 +40 1 497 499 498 500 505 506 +41 1 508 510 509 519 520 523 +42 1 520 522 521 541 542 545 +43 1 542 544 543 556 557 560 +44 1 557 559 558 563 564 567 +45 3 564 566 565 582 583 589 +46 3 583 585 584 596 597 603 +47 1 597 599 598 610 611 614 +48 1 611 613 612 622 623 626 +49 1 623 625 624 639 640 643 +50 1 629 631 630 632 637 638 +51 1 640 642 641 656 657 660 +52 1 646 648 647 649 654 655 +53 1 657 659 658 680 681 684 +54 1 681 683 682 699 700 703 +55 1 700 702 701 718 719 722 +56 1 719 721 720 738 739 742 +57 2 724 727 725 726 728 733 +58 2 724 726 725 727 729 734 +59 2 725 733 726 728 730 735 +60 2 725 734 727 729 730 736 +61 2 726 735 728 730 729 737 +62 2 727 736 729 730 728 737 +63 1 739 741 740 748 749 752 +64 1 749 751 750 755 756 759 +65 1 756 758 757 777 778 781 +66 1 778 780 779 794 795 798 +67 1 784 786 785 787 792 793 +68 1 795 797 796 813 814 817 +69 1 814 816 815 828 829 832 +70 1 829 831 830 840 841 844 +71 1 841 843 842 847 848 851 +72 1 848 850 849 871 872 875 +73 1 872 874 873 885 886 889 +74 1 886 888 887 904 905 908 +75 1 905 907 906 915 916 919 +76 1 916 918 917 927 928 931 +77 1 928 930 929 948 949 952 +78 2 933 936 934 935 937 943 +79 2 933 935 934 936 938 944 +80 2 934 943 935 937 939 945 +81 2 934 944 936 938 939 946 +82 2 935 945 937 939 938 940 +83 2 936 946 938 939 937 940 +84 1 949 951 950 962 963 966 +85 1 954 956 955 957 960 961 +86 1 963 965 964 981 982 985 +87 1 982 984 983 998 999 1002 +88 1 988 990 989 991 996 997 +89 1 999 1001 1000 1020 1021 1024 +90 1 1021 1023 1022 1035 1036 1039 +91 1 1036 1038 1037 1046 1047 1050 +92 1 1047 1049 1048 1060 1061 1064 +93 1 1061 1063 1062 1079 1080 1083 +94 1 1080 1082 1081 1097 1098 1101 +95 4 1085 1088 1086 1087 1089 1093 +96 5 1085 1087 1086 1088 1090 1094 +97 6 1086 1093 1087 1089 1090 1095 +98 4 1086 1094 1088 1090 1089 1096 +99 6 1087 1095 1089 1090 1088 1096 +100 1 1098 1100 1099 1116 1117 1120 +101 1 1117 1119 1118 1132 1133 1136 +102 1 1133 1135 1134 1151 1152 1155 +103 1 1152 1154 1153 1175 1176 1179 +104 1 1176 1178 1177 1194 1195 1198 +105 1 1195 1197 1196 1218 1219 1222 +106 1 1219 1221 1220 1225 1226 1229 + +PiTorsion Coeffs + +1 6.85 +2 6.85 +3 6.85 +4 6.85 +5 6.85 +6 6.85 + Tinker Types 1 234 diff --git a/examples/amoeba/in.ubiquitin b/examples/amoeba/in.ubiquitin index 0d7a708826..367030ba74 100644 --- a/examples/amoeba/in.ubiquitin +++ b/examples/amoeba/in.ubiquitin @@ -14,15 +14,16 @@ improper_style amoeba # per-atom properties required by AMOEBA or HIPPO fix amtype all property/atom i_amtype ghost yes -#fix pitorsion all pitorsion +fix pitorsion all pitorsion fix extra all property/atom & i_amgroup i_ired i_xaxis i_yaxis i_zaxis d_pval ghost yes fix extra2 all property/atom i_polaxe -read_data data.ubiquitin fix amtype NULL "Tinker Types" -#read_data data.ubiquitin fix amtype NULL "Tinker Types" & -# fix pitorsion pitorsions PiTorsions +#read_data data.ubiquitin fix amtype NULL "Tinker Types" +read_data data.ubiquitin fix amtype NULL "Tinker Types" & + fix pitorsion "pitorsion types" "PiTorsion Coeffs" & + fix pitorsion pitorsions PiTorsions pair_style amoeba pair_coeff * * amoeba_ubiquitin.prm amoeba_ubiquitin.key diff --git a/src/AMOEBA/angle_amoeba.cpp b/src/AMOEBA/angle_amoeba.cpp index a578396d10..e81bbff00f 100644 --- a/src/AMOEBA/angle_amoeba.cpp +++ b/src/AMOEBA/angle_amoeba.cpp @@ -103,10 +103,6 @@ void AngleAmoeba::compute(int eflag, int vflag) ev_init(eflag,vflag); - // DEBUG - int ubn = 0; - double eub = 0.0; - for (n = 0; n < nanglelist; n++) { i1 = anglelist[n][0]; i2 = anglelist[n][1]; @@ -131,15 +127,8 @@ void AngleAmoeba::compute(int eflag, int vflag) // Urey-Bradley H-H bond term within water molecules uflag = ubflag[type]; - - if (uflag) { - ubn++; - eub += tinker_urey_bradley(i1,i3,type,eflag); - } + if (uflag) tinker_urey_bradley(i1,i3,type,eflag); } - - // DEBUG - printf("UreyBradley n %d eng %g\n",ubn,eub); } /* ---------------------------------------------------------------------- */ @@ -543,7 +532,7 @@ void AngleAmoeba::tinker_bondangle(int i1, int i2, int i3, int type, int eflag) /* ---------------------------------------------------------------------- */ -double AngleAmoeba::tinker_urey_bradley(int i1, int i2, int type, int eflag) +void AngleAmoeba::tinker_urey_bradley(int i1, int i2, int type, int eflag) { double delx,dely,delz; double rsq,r,dr,rk; @@ -585,8 +574,6 @@ double AngleAmoeba::tinker_urey_bradley(int i1, int i2, int type, int eflag) } if (evflag) ev_tally2(i1,i2,nlocal,newton_bond,ebond,fbond,delx,dely,delz); - - return ebond; } /* ---------------------------------------------------------------------- */ diff --git a/src/AMOEBA/angle_amoeba.h b/src/AMOEBA/angle_amoeba.h index 281f4a9adb..69a782b48b 100644 --- a/src/AMOEBA/angle_amoeba.h +++ b/src/AMOEBA/angle_amoeba.h @@ -46,7 +46,7 @@ class AngleAmoeba : public Angle { void tinker_angle(int, int, int, int, int); void tinker_anglep(int, int, int, int, int); void tinker_bondangle(int, int, int, int, int); - double tinker_urey_bradley(int, int, int, int); + void tinker_urey_bradley(int, int, int, int); void allocate(); }; diff --git a/src/AMOEBA/fix_pitorsion.cpp b/src/AMOEBA/fix_pitorsion.cpp index ec8f0d71be..939220d95d 100644 --- a/src/AMOEBA/fix_pitorsion.cpp +++ b/src/AMOEBA/fix_pitorsion.cpp @@ -89,6 +89,10 @@ FixPiTorsion::FixPiTorsion(LAMMPS *lmp, int narg, char **arg) : npitorsion_list = 0; max_pitorsion_list = 0; pitorsion_list = nullptr; + + // pitorsion coeff + + kpit = nullptr; } /* --------------------------------------------------------------------- */ @@ -114,6 +118,10 @@ FixPiTorsion::~FixPiTorsion() // compute list memory->destroy(pitorsion_list); + + // coeff + + memory->destroy(kpit); } /* ---------------------------------------------------------------------- */ @@ -185,19 +193,19 @@ void FixPiTorsion::pre_neighbor() int i,m,atom1,atom2,atom3,atom4,atom5,atom6; // guesstimate initial length of local pitorsion list - // if npitorsion_global was not set (due to read_restart, no read_data), + // if npitorsions was not set (due to read_restart, no read_data), // then list will grow by LISTDELTA chunks if (max_pitorsion_list == 0) { - if (nprocs == 1) max_pitorsion_list = npitorsion_global; + if (nprocs == 1) max_pitorsion_list = npitorsions; else max_pitorsion_list = - static_cast (LB_FACTOR*npitorsion_global/nprocs); + static_cast (LB_FACTOR*npitorsions/nprocs); memory->create(pitorsion_list,max_pitorsion_list,7, "pitorsion:pitorsion_list"); } int nlocal = atom->nlocal; - pitorsion_list = 0; + npitorsion_list = 0; for (i = 0; i < nlocal; i++) { for (m = 0; m < num_pitorsion[i]; m++) { @@ -209,7 +217,7 @@ void FixPiTorsion::pre_neighbor() atom6 = atom->map(pitorsion_atom6[i][m]); if (atom1 == -1 || atom2 == -1 || atom3 == -1 || - atom4 == -1 || atom5 == -1) + atom4 == -1 || atom5 == -1 || atom6 == -1) error->one(FLERR,"PiTorsion atoms {} {} {} {} {} {} missing on " "proc {} at step {}", pitorsion_atom1[i][m],pitorsion_atom2[i][m], @@ -531,7 +539,9 @@ double FixPiTorsion::compute_scalar() void FixPiTorsion::read_data_header(char *line) { if (strstr(line,"pitorsions")) { - sscanf(line,BIGINT_FORMAT,&npitorsion_global); + sscanf(line,BIGINT_FORMAT,&npitorsions); + } else if (strstr(line,"pitorsion types")) { + sscanf(line,"%d",&npitorsion_types); } else error->all(FLERR,"Invalid read data header line for fix pitorsion"); // didn't set in constructor because this fix could be defined @@ -549,123 +559,172 @@ void FixPiTorsion::read_data_header(char *line) void FixPiTorsion::read_data_section(char *keyword, int n, char *buf, tagint id_offset) { - int m,tmp,itype; - tagint atom1,atom2,atom3,atom4,atom5,atom6; - char *next; + int which; - next = strchr(buf,'\n'); - *next = '\0'; - int nwords = utils::count_words(utils::trim_comment(buf)); - *next = '\n'; + if (strstr(keyword,"PiTorsions")) { + sscanf(keyword,BIGINT_FORMAT,&npitorsions); + which = 0; + } else if (strstr(keyword,"PiTorsion Coeffs")) { + sscanf(keyword,"%d",&npitorsion_types); + which = 1; + } else error->all(FLERR,"Invalid read data section for fix pitorsion"); + + // loop over lines of PiTorsion Coeffs + // tokenize the line into values + // initialize kpit vector + + if (which == 1) { + int itype; + double value; + char *next; - if (nwords != 7) - error->all(FLERR,"Incorrect {} format in data file",keyword); + memory->create(kpit,npitorsion_types+1,"pitorsion:kpit"); + + for (int i = 0; i < n; i++) { + next = strchr(buf,'\n'); + *next = '\0'; + sscanf(buf,"%d %g",&itype,&value); + if (itype <= 0 || itype > npitorsion_types) + error->all(FLERR,"Incorrect args for pitorsion coefficients"); + kpit[itype] = value; + buf = next + 1; + } + } // loop over lines of PiTorsions // tokenize the line into values // add PiTorsion to one or more of my atoms, depending on newton_bond - for (int i = 0; i < n; i++) { + if (which == 0) { + + int m,tmp,itype; + tagint atom1,atom2,atom3,atom4,atom5,atom6; + char *next; + next = strchr(buf,'\n'); *next = '\0'; - sscanf(buf,"%d %d " TAGINT_FORMAT " " TAGINT_FORMAT " " TAGINT_FORMAT - " " TAGINT_FORMAT " " TAGINT_FORMAT " " TAGINT_FORMAT, - &tmp,&itype,&atom1,&atom2,&atom3,&atom4,&atom5,&atom6); + int nwords = utils::count_words(utils::trim_comment(buf)); + *next = '\n'; + + if (nwords != 8) + error->all(FLERR,"Incorrect {} format in data file",keyword); - atom1 += id_offset; - atom2 += id_offset; - atom3 += id_offset; - atom4 += id_offset; - atom5 += id_offset; - atom6 += id_offset; + for (int i = 0; i < n; i++) { + next = strchr(buf,'\n'); + *next = '\0'; + sscanf(buf,"%d %d " TAGINT_FORMAT " " TAGINT_FORMAT " " TAGINT_FORMAT + " " TAGINT_FORMAT " " TAGINT_FORMAT " " TAGINT_FORMAT, + &tmp,&itype,&atom1,&atom2,&atom3,&atom4,&atom5,&atom6); - if ((m = atom->map(atom1)) >= 0) { - if (num_pitorsion[m] == PITORSIONMAX) - error->one(FLERR,"Too many PiTorsions for one atom"); - pitorsion_type[m][num_pitorsion[m]] = itype; - pitorsion_atom1[m][num_pitorsion[m]] = atom1; - pitorsion_atom2[m][num_pitorsion[m]] = atom2; - pitorsion_atom3[m][num_pitorsion[m]] = atom3; - pitorsion_atom4[m][num_pitorsion[m]] = atom4; - pitorsion_atom5[m][num_pitorsion[m]] = atom5; - pitorsion_atom6[m][num_pitorsion[m]] = atom6; - num_pitorsion[m]++; + atom1 += id_offset; + atom2 += id_offset; + atom3 += id_offset; + atom4 += id_offset; + atom5 += id_offset; + atom6 += id_offset; + + // atom3 owns the pitorsion when newton_bond on + + if ((m = atom->map(atom3)) >= 0) { + if (num_pitorsion[m] == PITORSIONMAX) + error->one(FLERR,"Too many PiTorsions for one atom"); + pitorsion_type[m][num_pitorsion[m]] = itype; + pitorsion_atom1[m][num_pitorsion[m]] = atom1; + pitorsion_atom2[m][num_pitorsion[m]] = atom2; + pitorsion_atom3[m][num_pitorsion[m]] = atom3; + pitorsion_atom4[m][num_pitorsion[m]] = atom4; + pitorsion_atom5[m][num_pitorsion[m]] = atom5; + pitorsion_atom6[m][num_pitorsion[m]] = atom6; + num_pitorsion[m]++; + } + + if (newton_bond == 0) { + if ((m = atom->map(atom1)) >= 0) { + if (num_pitorsion[m] == PITORSIONMAX) + error->one(FLERR,"Too many PiTorsions for one atom"); + pitorsion_type[m][num_pitorsion[m]] = itype; + pitorsion_atom1[m][num_pitorsion[m]] = atom1; + pitorsion_atom2[m][num_pitorsion[m]] = atom2; + pitorsion_atom3[m][num_pitorsion[m]] = atom3; + pitorsion_atom4[m][num_pitorsion[m]] = atom4; + pitorsion_atom5[m][num_pitorsion[m]] = atom5; + pitorsion_atom6[m][num_pitorsion[m]] = atom6; + num_pitorsion[m]++; + } + } + + if (newton_bond == 0) { + if ((m = atom->map(atom2)) >= 0) { + if (num_pitorsion[m] == PITORSIONMAX) + error->one(FLERR,"Too many PiTorsions for one atom"); + pitorsion_type[m][num_pitorsion[m]] = itype; + pitorsion_atom1[m][num_pitorsion[m]] = atom1; + pitorsion_atom2[m][num_pitorsion[m]] = atom2; + pitorsion_atom3[m][num_pitorsion[m]] = atom3; + pitorsion_atom4[m][num_pitorsion[m]] = atom4; + pitorsion_atom5[m][num_pitorsion[m]] = atom5; + pitorsion_atom6[m][num_pitorsion[m]] = atom6; + num_pitorsion[m]++; + } + } + + if (newton_bond == 0) { + if ((m = atom->map(atom4)) >= 0) { + if (num_pitorsion[m] == PITORSIONMAX) + error->one(FLERR,"Too many PiTorsions for one atom"); + pitorsion_type[m][num_pitorsion[m]] = itype; + pitorsion_atom1[m][num_pitorsion[m]] = atom1; + pitorsion_atom2[m][num_pitorsion[m]] = atom2; + pitorsion_atom3[m][num_pitorsion[m]] = atom3; + pitorsion_atom4[m][num_pitorsion[m]] = atom4; + pitorsion_atom5[m][num_pitorsion[m]] = atom5; + pitorsion_atom6[m][num_pitorsion[m]] = atom6; + num_pitorsion[m]++; + } + } + + if (newton_bond == 0) { + if ((m = atom->map(atom5)) >= 0) { + if (num_pitorsion[m] == PITORSIONMAX) + error->one(FLERR,"Too many PiTorsions for one atom"); + pitorsion_type[m][num_pitorsion[m]] = itype; + pitorsion_atom1[m][num_pitorsion[m]] = atom1; + pitorsion_atom2[m][num_pitorsion[m]] = atom2; + pitorsion_atom3[m][num_pitorsion[m]] = atom3; + pitorsion_atom4[m][num_pitorsion[m]] = atom4; + pitorsion_atom5[m][num_pitorsion[m]] = atom5; + pitorsion_atom6[m][num_pitorsion[m]] = atom6; + num_pitorsion[m]++; + } + } + + if (newton_bond == 0) { + if ((m = atom->map(atom6)) >= 0) { + if (num_pitorsion[m] == PITORSIONMAX) + error->one(FLERR,"Too many PiTorsions for one atom"); + pitorsion_type[m][num_pitorsion[m]] = itype; + pitorsion_atom1[m][num_pitorsion[m]] = atom1; + pitorsion_atom2[m][num_pitorsion[m]] = atom2; + pitorsion_atom3[m][num_pitorsion[m]] = atom3; + pitorsion_atom4[m][num_pitorsion[m]] = atom4; + pitorsion_atom5[m][num_pitorsion[m]] = atom5; + pitorsion_atom6[m][num_pitorsion[m]] = atom6; + num_pitorsion[m]++; + } + } + + buf = next + 1; } - - if ((m = atom->map(atom2)) >= 0) { - if (num_pitorsion[m] == PITORSIONMAX) - error->one(FLERR,"Too many PiTorsions for one atom"); - pitorsion_type[m][num_pitorsion[m]] = itype; - pitorsion_atom1[m][num_pitorsion[m]] = atom1; - pitorsion_atom2[m][num_pitorsion[m]] = atom2; - pitorsion_atom3[m][num_pitorsion[m]] = atom3; - pitorsion_atom4[m][num_pitorsion[m]] = atom4; - pitorsion_atom5[m][num_pitorsion[m]] = atom5; - pitorsion_atom6[m][num_pitorsion[m]] = atom6; - num_pitorsion[m]++; - } - - if ((m = atom->map(atom3)) >= 0) { - if (num_pitorsion[m] == PITORSIONMAX) - error->one(FLERR,"Too many PiTorsions for one atom"); - pitorsion_type[m][num_pitorsion[m]] = itype; - pitorsion_atom1[m][num_pitorsion[m]] = atom1; - pitorsion_atom2[m][num_pitorsion[m]] = atom2; - pitorsion_atom3[m][num_pitorsion[m]] = atom3; - pitorsion_atom4[m][num_pitorsion[m]] = atom4; - pitorsion_atom5[m][num_pitorsion[m]] = atom5; - pitorsion_atom6[m][num_pitorsion[m]] = atom6; - num_pitorsion[m]++; - } - - if ((m = atom->map(atom4)) >= 0) { - if (num_pitorsion[m] == PITORSIONMAX) - error->one(FLERR,"Too many PiTorsions for one atom"); - pitorsion_type[m][num_pitorsion[m]] = itype; - pitorsion_atom1[m][num_pitorsion[m]] = atom1; - pitorsion_atom2[m][num_pitorsion[m]] = atom2; - pitorsion_atom3[m][num_pitorsion[m]] = atom3; - pitorsion_atom4[m][num_pitorsion[m]] = atom4; - pitorsion_atom5[m][num_pitorsion[m]] = atom5; - pitorsion_atom6[m][num_pitorsion[m]] = atom6; - num_pitorsion[m]++; - } - - if ((m = atom->map(atom5)) >= 0) { - if (num_pitorsion[m] == PITORSIONMAX) - error->one(FLERR,"Too many PiTorsions for one atom"); - pitorsion_type[m][num_pitorsion[m]] = itype; - pitorsion_atom1[m][num_pitorsion[m]] = atom1; - pitorsion_atom2[m][num_pitorsion[m]] = atom2; - pitorsion_atom3[m][num_pitorsion[m]] = atom3; - pitorsion_atom4[m][num_pitorsion[m]] = atom4; - pitorsion_atom5[m][num_pitorsion[m]] = atom5; - pitorsion_atom6[m][num_pitorsion[m]] = atom6; - num_pitorsion[m]++; - } - - if ((m = atom->map(atom6)) >= 0) { - if (num_pitorsion[m] == PITORSIONMAX) - error->one(FLERR,"Too many PiTorsions for one atom"); - pitorsion_type[m][num_pitorsion[m]] = itype; - pitorsion_atom1[m][num_pitorsion[m]] = atom1; - pitorsion_atom2[m][num_pitorsion[m]] = atom2; - pitorsion_atom3[m][num_pitorsion[m]] = atom3; - pitorsion_atom4[m][num_pitorsion[m]] = atom4; - pitorsion_atom5[m][num_pitorsion[m]] = atom5; - pitorsion_atom6[m][num_pitorsion[m]] = atom6; - num_pitorsion[m]++; - } - - buf = next + 1; } } /* ---------------------------------------------------------------------- */ -bigint FixPiTorsion::read_data_skip_lines(char * /*keyword*/) +bigint FixPiTorsion::read_data_skip_lines(char *keyword) { - return npitorsion_global; + if (strcmp(keyword,"PiTorsions") == 0) return npitorsions; + if (strcmp(keyword,"PiTorsion Coeffs") == 0) return (bigint) npitorsion_types; + return 0; } /* ---------------------------------------------------------------------- @@ -673,9 +732,11 @@ bigint FixPiTorsion::read_data_skip_lines(char * /*keyword*/) only called by proc 0 ------------------------------------------------------------------------- */ -void FixPiTorsion::write_data_header(FILE *fp, int /*mth*/) +void FixPiTorsion::write_data_header(FILE *fp, int mth) { - fprintf(fp,BIGINT_FORMAT " pitorsions\n",npitorsion_global); + if (mth == 0) fprintf(fp,BIGINT_FORMAT " pitorsions\n",npitorsions); + else if (mth == 1) + fprintf(fp,BIGINT_FORMAT " pitorsion types\n",npitorsion_types); } /* ---------------------------------------------------------------------- @@ -686,7 +747,7 @@ void FixPiTorsion::write_data_header(FILE *fp, int /*mth*/) ny = columns = type + 6 atom IDs ------------------------------------------------------------------------- */ -void FixPiTorsion::write_data_section_size(int /*mth*/, int &nx, int &ny) +void FixPiTorsion::write_data_section_size(int mth, int &nx, int &ny) { int i,m; @@ -708,7 +769,7 @@ void FixPiTorsion::write_data_section_size(int /*mth*/, int &nx, int &ny) buf allocated by caller as owned PiTorsions by 7 ------------------------------------------------------------------------- */ -void FixPiTorsion::write_data_section_pack(int /*mth*/, double **buf) +void FixPiTorsion::write_data_section_pack(int mth, double **buf) { int i,m; @@ -741,9 +802,10 @@ void FixPiTorsion::write_data_section_pack(int /*mth*/, double **buf) only called by proc 0 ------------------------------------------------------------------------- */ -void FixPiTorsion::write_data_section_keyword(int /*mth*/, FILE *fp) +void FixPiTorsion::write_data_section_keyword(int mth, FILE *fp) { - fprintf(fp,"\nPiTorsion\n\n"); + if (mth == 0) fprintf(fp,"\nPiTorsions\n\n"); + else if (mth == 1) fprintf(fp,"\nPiTorsion Coeffs\n\n"); } /* ---------------------------------------------------------------------- @@ -753,7 +815,7 @@ void FixPiTorsion::write_data_section_keyword(int /*mth*/, FILE *fp) only called by proc 0 ------------------------------------------------------------------------- */ -void FixPiTorsion::write_data_section(int /*mth*/, FILE *fp, +void FixPiTorsion::write_data_section(int mth, FILE *fp, int n, double **buf, int index) { for (int i = 0; i < n; i++) @@ -779,7 +841,7 @@ void FixPiTorsion::write_restart(FILE *fp) if (comm->me == 0) { int size = sizeof(bigint); fwrite(&size,sizeof(int),1,fp); - fwrite(&npitorsion_global,sizeof(bigint),1,fp); + fwrite(&npitorsions,sizeof(bigint),1,fp); } } @@ -789,7 +851,7 @@ void FixPiTorsion::write_restart(FILE *fp) void FixPiTorsion::restart(char *buf) { - npitorsion_global = *((bigint *) buf); + npitorsions = *((bigint *) buf); } /* ---------------------------------------------------------------------- diff --git a/src/AMOEBA/fix_pitorsion.h b/src/AMOEBA/fix_pitorsion.h index efb448a408..7e3258c66a 100644 --- a/src/AMOEBA/fix_pitorsion.h +++ b/src/AMOEBA/fix_pitorsion.h @@ -68,7 +68,8 @@ class FixPiTorsion : public Fix { int nprocs, me; int newton_bond, eflag_caller; int ilevel_respa; - bigint npitorsion_global; + bigint npitorsions; + int npitorsion_types; double epitorsion; double *kpit; diff --git a/src/modify.cpp b/src/modify.cpp index eff6ea8337..ef738ecc67 100644 --- a/src/modify.cpp +++ b/src/modify.cpp @@ -810,7 +810,7 @@ Fix *Modify::add_fix(int narg, char **arg, int trysuffix) const char *exceptions[] = {"GPU", "OMP", "INTEL", "property/atom", "cmap", "cmap3", "rx", - "deprecated", "STORE/KIM", nullptr}; + "deprecated", "STORE/KIM", "pitorsion", nullptr}; if (domain->box_exist == 0) { int m; diff --git a/src/read_data.cpp b/src/read_data.cpp index 5b68f9d94e..25e2db39bf 100644 --- a/src/read_data.cpp +++ b/src/read_data.cpp @@ -729,7 +729,6 @@ void ReadData::command(int narg, char **arg) if (firstpass) fix(fix_index[i],keyword); else skip_lines(modify->fix[fix_index[i]]-> read_data_skip_lines(keyword)); - parse_keyword(0); break; } if (i == nfix) diff --git a/tools/tinker/tinker2lmp.py b/tools/tinker/tinker2lmp.py index 95e0013e91..dfacebd832 100644 --- a/tools/tinker/tinker2lmp.py +++ b/tools/tinker/tinker2lmp.py @@ -718,7 +718,7 @@ for atom1 in id: # DEBUG - if uncommented, no PiTorsions appear in data file -pitorsionlist = [] +#pitorsionlist = [] # ---------------------------------------- # create lists of bond/angle/dihedral/improper types @@ -1055,32 +1055,31 @@ for m,params in enumerate(prm.pitorsionparams): flags = len(prm.pitorsionparams)*[0] pitorsiontype = [] pitorsionparams = [] +pitorsionlist_reduced = [] for tmp1,tmp2,atom1,atom2,tmp3,tmp4 in pitorsionlist: type1 = type[atom1-1] type2 = type[atom2-1] c1 = classes[type1-1] c2 = classes[type2-1] - - if (c1,c2) in pitdict: m,params = pitdict[(c1,c2)] - elif (c2,c1) in pitdict: m,params = pitdict[(c2,c1)] - else: - # NOTE: probably this PiT should be deleted from enumeration list - # similar to olist for impropers above - # IMPORTANT: look at other errors and messages t2lmp.py is producing - error("PiTorsion not found: %d %d: %d %d" % (atom1,atom2,c1,c2)) - pitorsiontype.append(0) - continue - - if not flags[m]: - v1 = params[2:] - pitorsionparams.append(v1) - flags[m] = len(pitorsionparams) - pitorsiontype.append(flags[m]) -print "PRM pitor param",len(prm.pitorsionparams) -print "PiTor list",len(pitorsionlist) -#print "Flags",flags + # 6-tuple is only a PiTorsion if central 2 atoms math an entry in PRM file + # pitorsionlist_reduced = list of just these 6-tuples + + if (c1,c2) in pitdict or (c2,c1) in pitdict: + if (c1,c2) in pitdict: m,params = pitdict[(c1,c2)] + else: m,params = pitdict[(c2,c1)] + pitorsionlist_reduced.append((tmp1,tmp2,atom1,atom2,tmp3,tmp4)) + + if not flags[m]: + v1 = params[2:] + pitorsionparams.append(v1) + flags[m] = len(pitorsionparams) + pitorsiontype.append(flags[m]) + +# replace original pitorsionlist with reduced version + +pitorsionlist = pitorsionlist_reduced # ---------------------------------------- # assign each atom to a Tinker group From d5bc69f28b4666c240585b060e6452eedbd92b88 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Wed, 9 Mar 2022 17:41:42 -0700 Subject: [PATCH 082/585] support for writing data files --- src/AMOEBA/fix_pitorsion.cpp | 95 +++++++++++++++++++++++------------- 1 file changed, 60 insertions(+), 35 deletions(-) diff --git a/src/AMOEBA/fix_pitorsion.cpp b/src/AMOEBA/fix_pitorsion.cpp index 939220d95d..ebfb6b37ff 100644 --- a/src/AMOEBA/fix_pitorsion.cpp +++ b/src/AMOEBA/fix_pitorsion.cpp @@ -741,27 +741,35 @@ void FixPiTorsion::write_data_header(FILE *fp, int mth) /* ---------------------------------------------------------------------- return size I own for Mth data section - # of data sections = 1 for this fix - nx = # of PiTorsions owned by my local atoms - if newton_bond off, atom only owns PiTorsion if it is atom3 - ny = columns = type + 6 atom IDs + # of data sections = 2 for this fix ------------------------------------------------------------------------- */ void FixPiTorsion::write_data_section_size(int mth, int &nx, int &ny) { int i,m; - tagint *tag = atom->tag; - int nlocal = atom->nlocal; + // PiTorsions section + // nx = # of PiTorsions owned by my local atoms + // if newton_bond off, atom only owns PiTorsion if it is atom3 + // ny = 7 columns = type + 6 atom IDs - nx = 0; - for (i = 0; i < nlocal; i++) - for (m = 0; m < num_pitorsion[i]; m++) - if (pitorsion_atom3[i][m] == tag[i]) nx++; + if (mth == 0) { + tagint *tag = atom->tag; + int nlocal = atom->nlocal; - // NOTE: should be a check for newton bond? + nx = 0; + for (i = 0; i < nlocal; i++) + for (m = 0; m < num_pitorsion[i]; m++) + if (pitorsion_atom3[i][m] == tag[i]) nx++; - ny = 7; + ny = 7; + + // PiTorsion Coeffs section + // nx = # of PiTorsion types + // ny = 2 columns = PiTorsion type + value + + } else if (mth == 1) { + } } /* ---------------------------------------------------------------------- @@ -773,26 +781,35 @@ void FixPiTorsion::write_data_section_pack(int mth, double **buf) { int i,m; + // PiTorsions section // 1st column = PiTorsion type - // 2nd-6th columns = 5 atom IDs + // 2nd-7th columns = 6 atom IDs - tagint *tag = atom->tag; - int nlocal = atom->nlocal; + if (mth == 0) { - int n = 0; - for (i = 0; i < nlocal; i++) { - for (m = 0; m < num_pitorsion[i]; m++) { - // NOTE: check for newton bond on/off ? - if (pitorsion_atom3[i][m] != tag[i]) continue; - buf[n][0] = ubuf(pitorsion_type[i][m]).d; - buf[n][1] = ubuf(pitorsion_atom1[i][m]).d; - buf[n][2] = ubuf(pitorsion_atom2[i][m]).d; - buf[n][3] = ubuf(pitorsion_atom3[i][m]).d; - buf[n][4] = ubuf(pitorsion_atom4[i][m]).d; - buf[n][5] = ubuf(pitorsion_atom5[i][m]).d; - buf[n][6] = ubuf(pitorsion_atom6[i][m]).d; - n++; + tagint *tag = atom->tag; + int nlocal = atom->nlocal; + + int n = 0; + for (i = 0; i < nlocal; i++) { + for (m = 0; m < num_pitorsion[i]; m++) { + if (pitorsion_atom3[i][m] != tag[i]) continue; + buf[n][0] = ubuf(pitorsion_type[i][m]).d; + buf[n][1] = ubuf(pitorsion_atom1[i][m]).d; + buf[n][2] = ubuf(pitorsion_atom2[i][m]).d; + buf[n][3] = ubuf(pitorsion_atom3[i][m]).d; + buf[n][4] = ubuf(pitorsion_atom4[i][m]).d; + buf[n][5] = ubuf(pitorsion_atom5[i][m]).d; + buf[n][6] = ubuf(pitorsion_atom6[i][m]).d; + n++; + } } + + // PiTorsion Coeffs section + // 1st column = pitorsion type + // 2nd column = value + + } else if (mth == 1) { } } @@ -816,14 +833,22 @@ void FixPiTorsion::write_data_section_keyword(int mth, FILE *fp) ------------------------------------------------------------------------- */ void FixPiTorsion::write_data_section(int mth, FILE *fp, - int n, double **buf, int index) + int n, double **buf, int index) { - for (int i = 0; i < n; i++) - fprintf(fp,"%d %d " TAGINT_FORMAT " " TAGINT_FORMAT - " " TAGINT_FORMAT " " TAGINT_FORMAT " " TAGINT_FORMAT "\n", - index+i,(int) ubuf(buf[i][0]).i,(tagint) ubuf(buf[i][1]).i, - (tagint) ubuf(buf[i][2]).i,(tagint) ubuf(buf[i][3]).i, - (tagint) ubuf(buf[i][4]).i,(tagint) ubuf(buf[i][5]).i); + // PiTorsions section + + if (mth == 0) { + for (int i = 0; i < n; i++) + fprintf(fp,"%d %d " TAGINT_FORMAT " " TAGINT_FORMAT + " " TAGINT_FORMAT " " TAGINT_FORMAT " " TAGINT_FORMAT "\n", + index+i,(int) ubuf(buf[i][0]).i,(tagint) ubuf(buf[i][1]).i, + (tagint) ubuf(buf[i][2]).i,(tagint) ubuf(buf[i][3]).i, + (tagint) ubuf(buf[i][4]).i,(tagint) ubuf(buf[i][5]).i); + + // PiTorsion Coeffs section + + } else if (mth == 1) { + } } // ---------------------------------------------------------------------- From 0658844e04ad83f814a43e08308d6ad827732d2c Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Thu, 10 Mar 2022 16:00:05 -0700 Subject: [PATCH 083/585] first working version of fix pitorsion --- examples/amoeba/in.ubiquitin | 1 + src/AMOEBA/amoeba_dispersion.cpp | 4 +- src/AMOEBA/amoeba_induce.cpp | 12 +- src/AMOEBA/amoeba_multipole.cpp | 4 +- src/AMOEBA/amoeba_polar.cpp | 4 +- src/AMOEBA/angle_amoeba.cpp | 41 +++- src/AMOEBA/angle_amoeba.h | 3 + src/AMOEBA/fix_pitorsion.cpp | 305 ++++++++++++++---------- src/AMOEBA/fix_pitorsion.h | 2 + src/AMOEBA/improper_amoeba.cpp | 12 +- src/AMOEBA/improper_amoeba.h | 1 + src/AMOEBA/pair_amoeba.cpp | 131 +++++----- src/AMOEBA/pair_amoeba.h | 12 +- src/CLASS2/bond_class2.cpp | 20 +- src/CLASS2/bond_class2.h | 2 + src/EXTRA-MOLECULE/dihedral_fourier.cpp | 21 +- src/EXTRA-MOLECULE/dihedral_fourier.h | 2 + 17 files changed, 354 insertions(+), 223 deletions(-) diff --git a/examples/amoeba/in.ubiquitin b/examples/amoeba/in.ubiquitin index 367030ba74..6f7d605af0 100644 --- a/examples/amoeba/in.ubiquitin +++ b/examples/amoeba/in.ubiquitin @@ -15,6 +15,7 @@ improper_style amoeba fix amtype all property/atom i_amtype ghost yes fix pitorsion all pitorsion +fix_modify pitorsion energy yes fix extra all property/atom & i_amgroup i_ired i_xaxis i_yaxis i_zaxis d_pval ghost yes diff --git a/src/AMOEBA/amoeba_dispersion.cpp b/src/AMOEBA/amoeba_dispersion.cpp index bf9b3be11a..d19bceb14a 100644 --- a/src/AMOEBA/amoeba_dispersion.cpp +++ b/src/AMOEBA/amoeba_dispersion.cpp @@ -44,11 +44,11 @@ void PairAmoeba::dispersion() // compute the real space portion of the Ewald summation - if (rspace_flag) dispersion_real(); + if (disp_rspace_flag) dispersion_real(); // compute the reciprocal space part of the Ewald summation - if (kspace_flag) dispersion_kspace(); + if (disp_kspace_flag) dispersion_kspace(); // compute the self-energy portion of the Ewald summation diff --git a/src/AMOEBA/amoeba_induce.cpp b/src/AMOEBA/amoeba_induce.cpp index c8f361053c..e644f7759a 100644 --- a/src/AMOEBA/amoeba_induce.cpp +++ b/src/AMOEBA/amoeba_induce.cpp @@ -40,6 +40,8 @@ enum{GORDON1,GORDON2}; #define DEBYE 4.80321 // conversion factor from q-Angs (real units) to Debye +#define UIND_DEBUG 0 + /* ---------------------------------------------------------------------- induce = induced dipole moments via pre-conditioned CG solver adapted from Tinker induce0a() routine @@ -539,7 +541,7 @@ void PairAmoeba::induce() // DEBUG output to dump file - if (uind_flag) + if (UIND_DEBUG) dump6(fp_uind,"id uindx uindy uindz uinpx uinpy uinpz",DEBYE,uind,uinp); // deallocation of arrays @@ -715,11 +717,11 @@ void PairAmoeba::ufield0c(double **field, double **fieldp) // get the reciprocal space part of the mutual field - if (kspace_flag) umutual1(field,fieldp); + if (polar_kspace_flag) umutual1(field,fieldp); // get the real space portion of the mutual field - if (rspace_flag) umutual2b(field,fieldp); + if (polar_rspace_flag) umutual2b(field,fieldp); // add the self-energy portion of the mutual field @@ -983,7 +985,7 @@ void PairAmoeba::dfield0c(double **field, double **fieldp) // get the reciprocal space part of the permanent field - if (kspace_flag) udirect1(field); + if (polar_kspace_flag) udirect1(field); for (i = 0; i < nlocal; i++) { for (j = 0; j < 3; j++) { @@ -993,7 +995,7 @@ void PairAmoeba::dfield0c(double **field, double **fieldp) // get the real space portion of the permanent field - if (rspace_flag) udirect2b(field,fieldp); + if (polar_rspace_flag) udirect2b(field,fieldp); // get the self-energy portion of the permanent field diff --git a/src/AMOEBA/amoeba_multipole.cpp b/src/AMOEBA/amoeba_multipole.cpp index c06f07d70c..894a1df835 100644 --- a/src/AMOEBA/amoeba_multipole.cpp +++ b/src/AMOEBA/amoeba_multipole.cpp @@ -85,12 +85,12 @@ void PairAmoeba::multipole() // compute the real space part of the Ewald summation - if (rspace_flag) multipole_real(); + if (mpole_rspace_flag) multipole_real(); // compute the reciprocal space part of the Ewald summation //printf("zero check %e \n",empole); - if (kspace_flag) multipole_kspace(); + if (mpole_kspace_flag) multipole_kspace(); //printf("kspace energy %e \n",empole); // compute the Ewald self-energy term over all the atoms diff --git a/src/AMOEBA/amoeba_polar.cpp b/src/AMOEBA/amoeba_polar.cpp index 1503243220..83a07caa2e 100644 --- a/src/AMOEBA/amoeba_polar.cpp +++ b/src/AMOEBA/amoeba_polar.cpp @@ -80,11 +80,11 @@ void PairAmoeba::polar() // compute the real space part of the dipole interactions - if (rspace_flag) polar_real(); + if (polar_rspace_flag) polar_real(); // compute the reciprocal space part of dipole interactions - if (kspace_flag) polar_kspace(); + if (polar_kspace_flag) polar_kspace(); // compute the Ewald self-energy torque and virial terms diff --git a/src/AMOEBA/angle_amoeba.cpp b/src/AMOEBA/angle_amoeba.cpp index e81bbff00f..216a79ff83 100644 --- a/src/AMOEBA/angle_amoeba.cpp +++ b/src/AMOEBA/angle_amoeba.cpp @@ -21,6 +21,7 @@ #include "domain.h" #include "comm.h" #include "force.h" +#include "pair.h" #include "math_const.h" #include "memory.h" #include "error.h" @@ -112,22 +113,26 @@ void AngleAmoeba::compute(int eflag, int vflag) // tflag = 0 for "angle", 1 for "anglep" in Tinker PRM file // atom 2 must have exactly 3 bond partners to invoke anglep() variant - tflag = pflag[type]; + if (enable_angle) { + tflag = pflag[type]; - if (tflag && nspecial[i2][0] == 3) - tinker_anglep(i1,i2,i3,type,eflag); - else - tinker_angle(i1,i2,i3,type,eflag); + if (tflag && nspecial[i2][0] == 3) + tinker_anglep(i1,i2,i3,type,eflag); + else + tinker_angle(i1,i2,i3,type,eflag); - // bondangle = bond-stretch cross term in Tinker + // bondangle = bond-stretch cross term in Tinker - if (ba_k1[type] != 0.0) - tinker_bondangle(i1,i2,i3,type,eflag); + if (ba_k1[type] != 0.0) + tinker_bondangle(i1,i2,i3,type,eflag); + } // Urey-Bradley H-H bond term within water molecules - uflag = ubflag[type]; - if (uflag) tinker_urey_bradley(i1,i3,type,eflag); + if (enable_urey) { + uflag = ubflag[type]; + if (uflag) tinker_urey_bradley(i1,i3,type,eflag); + } } } @@ -690,6 +695,22 @@ void AngleAmoeba::coeff(int narg, char **arg) /* ---------------------------------------------------------------------- */ +void AngleAmoeba::init_style() +{ + // check if PairAmoeba disabled angle or Urey-Bradley terms + + Pair *pair = force->pair_match("amoeba",1,0); + + if (!pair) enable_angle = enable_urey = 1; + else { + int tmp; + enable_angle = *((int *) pair->extract("angle_flag",tmp)); + enable_urey = *((int *) pair->extract("urey_flag",tmp)); + } +} + +/* ---------------------------------------------------------------------- */ + double AngleAmoeba::equilibrium_angle(int i) { return theta0[i]; diff --git a/src/AMOEBA/angle_amoeba.h b/src/AMOEBA/angle_amoeba.h index 69a782b48b..05d8041286 100644 --- a/src/AMOEBA/angle_amoeba.h +++ b/src/AMOEBA/angle_amoeba.h @@ -30,6 +30,7 @@ class AngleAmoeba : public Angle { virtual ~AngleAmoeba(); void compute(int, int); void coeff(int, char **); + void init_style(); double equilibrium_angle(int); void write_restart(FILE *); void read_restart(FILE *); @@ -43,6 +44,8 @@ class AngleAmoeba : public Angle { double *ub_k, *ub_r0; int *setflag_a, *setflag_ba, *setflag_ub; + int enable_angle,enable_urey; + void tinker_angle(int, int, int, int, int); void tinker_anglep(int, int, int, int, int); void tinker_bondangle(int, int, int, int, int); diff --git a/src/AMOEBA/fix_pitorsion.cpp b/src/AMOEBA/fix_pitorsion.cpp index ebfb6b37ff..b474c34202 100644 --- a/src/AMOEBA/fix_pitorsion.cpp +++ b/src/AMOEBA/fix_pitorsion.cpp @@ -22,6 +22,7 @@ #include "respa.h" #include "domain.h" #include "force.h" +#include "pair.h" #include "comm.h" #include "math_const.h" #include "memory.h" @@ -145,6 +146,21 @@ void FixPiTorsion::init() ilevel_respa = ((Respa *) update->integrate)->nlevels-1; if (respa_level >= 0) ilevel_respa = MIN(respa_level,ilevel_respa); } + + // check if PairAmoeba disabled pitorsion terms + + Pair *pair = force->pair_match("amoeba",1,0); + + if (!pair) disable = 0; + else { + int tmp; + int flag = *((int *) pair->extract("pitorsion_flag",tmp)); + disable = flag ? 0 : 1; + } + + // constant + + onesixth = 1.0/6.0; } /* --------------------------------------------------------------------- */ @@ -185,7 +201,9 @@ void FixPiTorsion::min_setup(int vflag) } /* ---------------------------------------------------------------------- - store local neighbor list for newton_bond ON + create local list of pitorsions + if one or more atoms in pitorsion are on this proc, + this proc lists the pitorsion exactly once ------------------------------------------------------------------------- */ void FixPiTorsion::pre_neighbor() @@ -231,6 +249,13 @@ void FixPiTorsion::pre_neighbor() atom5 = domain->closest_image(i,atom5); atom6 = domain->closest_image(i,atom6); + /* + if (atom1 >= nlocal || atom2 >= nlocal || atom3 >= nlocal || + atom4 >= nlocal || atom5 >= nlocal || atom6 >= nlocal) + printf("ATOM 123456: %d %d %d %d %d %d\n", + atom1,atom2,atom3,atom4,atom5,atom6); + */ + if (i <= atom1 && i <= atom2 && i <= atom3 && i <= atom4 && i <= atom5 && i <= atom6) { if (npitorsion_list == max_pitorsion_list) { @@ -261,13 +286,15 @@ void FixPiTorsion::pre_reverse(int eflag, int /*vflag*/) } /* ---------------------------------------------------------------------- - compute PiTorsion terms as if newton_bond = OFF, even if actually ON + compute PiTorsion terms ------------------------------------------------------------------------- */ void FixPiTorsion::post_force(int vflag) { + if (disable) return; + int ia,ib,ic,id,ie,ig,ptype; - double e,dedphi; + double e,dedphi,engfraction; double xt,yt,zt,rt2; double xu,yu,zu,ru2; double xtu,ytu,ztu; @@ -307,18 +334,24 @@ void FixPiTorsion::post_force(int vflag) double vxx,vyy,vzz; double vyx,vzx,vzy; - double **x = atom->x; - double **f = atom->f; + int nlist,list[6]; + double v[6]; epitorsion = 0.0; + int eflag = eflag_caller; + ev_init(eflag,vflag); + + double **x = atom->x; + double **f = atom->f; + int nlocal = atom->nlocal; for (int n = 0; n < npitorsion_list; n++) { ia = pitorsion_list[n][0]; - ib = pitorsion_list[n][0]; - ic = pitorsion_list[n][0]; - id = pitorsion_list[n][0]; - ie = pitorsion_list[n][0]; - ig = pitorsion_list[n][0]; + ib = pitorsion_list[n][1]; + ic = pitorsion_list[n][2]; + id = pitorsion_list[n][3]; + ie = pitorsion_list[n][4]; + ig = pitorsion_list[n][5]; ptype = pitorsion_list[n][6]; // compute the value of the pi-system torsion angle @@ -404,12 +437,16 @@ void FixPiTorsion::post_force(int vflag) dphi2 = 2.0 * (cosine2*s2 - sine2*c2); // calculate pi-system torsion energy and master chain rule term + // NOTE: remove ptornunit if 1.0 ? - // NOTE: is ptornunit 1.0 ? double ptorunit = 1.0; e = ptorunit * v2 * phi2; dedphi = ptorunit * v2 * dphi2; + // fraction of energy for each atom + + engfraction = e * onesixth; + // chain rule terms for first derivative components xdp = xid - xip; @@ -461,47 +498,73 @@ void FixPiTorsion::post_force(int vflag) dedyid = dedyid + dedyiq - dedyia - dedyib; dedzid = dedzid + dedziq - dedzia - dedzib; - // increment the total pi-system torsion energy and gradient + // forces and energy - epitorsion += e; + if (ia < nlocal) { + epitorsion += engfraction; + f[ia][0] += dedxia; + f[ia][1] += dedyia; + f[ia][2] += dedzia; + } - f[ia][0] += dedxia; - f[ia][1] += dedyia; - f[ia][2] += dedzia; - f[ib][0] += dedxib; - f[ib][1] += dedyib; - f[ib][2] += dedzib; - f[ic][0] += dedxic; - f[ic][1] += dedyic; - f[ic][2] += dedzic; - f[id][0] += dedxid; - f[id][1] += dedyid; - f[id][2] += dedzid; - f[ie][0] += dedxie; - f[ie][1] += dedyie; - f[ie][2] += dedzie; - f[ig][0] += dedxig; - f[ig][1] += dedyig; - f[ig][2] += dedzig; + if (ib < nlocal) { + epitorsion += engfraction; + f[ib][0] += dedxib; + f[ib][1] += dedyib; + f[ib][2] += dedzib; + } - // increment the internal virial tensor components + if (ic < nlocal) { + epitorsion += engfraction; + f[ic][0] += dedxic; + f[ic][1] += dedyic; + f[ic][2] += dedzic; + } - vxterm = dedxid + dedxia + dedxib; - vyterm = dedyid + dedyia + dedyib; - vzterm = dedzid + dedzia + dedzib; - vxx = xdc*vxterm + xcp*dedxip - xqd*dedxiq; - vyx = ydc*vxterm + ycp*dedxip - yqd*dedxiq; - vzx = zdc*vxterm + zcp*dedxip - zqd*dedxiq; - vyy = ydc*vyterm + ycp*dedyip - yqd*dedyiq; - vzy = zdc*vyterm + zcp*dedyip - zqd*dedyiq; - vzz = zdc*vzterm + zcp*dedzip - zqd*dedziq; + if (id < nlocal) { + epitorsion += engfraction; + f[id][0] += dedxid; + f[id][1] += dedyid; + f[id][2] += dedzid; + } - virial[0] += vxx; - virial[1] += vyy; - virial[2] += vzz; - virial[3] += vyx; - virial[4] += vzx; - virial[5] += vzy; + if (ie < nlocal) { + epitorsion += engfraction; + f[ie][0] += dedxie; + f[ie][1] += dedyie; + f[ie][2] += dedzie; + } + + if (ig < nlocal) { + epitorsion += engfraction; + f[ig][0] += dedxig; + f[ig][1] += dedyig; + f[ig][2] += dedzig; + } + + // virial tensor components + + if (evflag) { + nlist = 0; + if (ia < nlocal) list[nlist++] = ia; + if (ib < nlocal) list[nlist++] = ib; + if (ic < nlocal) list[nlist++] = ic; + if (id < nlocal) list[nlist++] = id; + if (ie < nlocal) list[nlist++] = ie; + if (ig < nlocal) list[nlist++] = ig; + + vxterm = dedxid + dedxia + dedxib; + vyterm = dedyid + dedyia + dedyib; + vzterm = dedzid + dedzia + dedzib; + v[0] = xdc*vxterm + xcp*dedxip - xqd*dedxiq; + v[1] = ydc*vyterm + ycp*dedyip - yqd*dedyiq; + v[2] = zdc*vzterm + zcp*dedzip - zqd*dedziq; + v[3] = ydc*vxterm + ycp*dedxip - yqd*dedxiq; + v[4] = zdc*vxterm + zcp*dedxip - zqd*dedxiq; + v[5] = zdc*vyterm + zcp*dedyip - zqd*dedyiq; + + ev_tally(nlist,list,6.0,e,v); + } } } @@ -543,17 +606,11 @@ void FixPiTorsion::read_data_header(char *line) } else if (strstr(line,"pitorsion types")) { sscanf(line,"%d",&npitorsion_types); } else error->all(FLERR,"Invalid read data header line for fix pitorsion"); - - // didn't set in constructor because this fix could be defined - // before newton command - - newton_bond = force->newton_bond; } /* ---------------------------------------------------------------------- unpack N lines in buf from section of data file labeled by keyword id_offset is applied to atomID fields if multiple data files are read - store PiTorsion interactions as if newton_bond = OFF, even if actually ON ------------------------------------------------------------------------- */ void FixPiTorsion::read_data_section(char *keyword, int n, char *buf, @@ -583,7 +640,7 @@ void FixPiTorsion::read_data_section(char *keyword, int n, char *buf, for (int i = 0; i < n; i++) { next = strchr(buf,'\n'); *next = '\0'; - sscanf(buf,"%d %g",&itype,&value); + sscanf(buf,"%d %lg",&itype,&value); if (itype <= 0 || itype > npitorsion_types) error->all(FLERR,"Incorrect args for pitorsion coefficients"); kpit[itype] = value; @@ -593,7 +650,7 @@ void FixPiTorsion::read_data_section(char *keyword, int n, char *buf, // loop over lines of PiTorsions // tokenize the line into values - // add PiTorsion to one or more of my atoms, depending on newton_bond + // each atom in the PiTorsion stores it if (which == 0) { @@ -623,8 +680,32 @@ void FixPiTorsion::read_data_section(char *keyword, int n, char *buf, atom5 += id_offset; atom6 += id_offset; - // atom3 owns the pitorsion when newton_bond on - + if ((m = atom->map(atom1)) >= 0) { + if (num_pitorsion[m] == PITORSIONMAX) + error->one(FLERR,"Too many PiTorsions for one atom"); + pitorsion_type[m][num_pitorsion[m]] = itype; + pitorsion_atom1[m][num_pitorsion[m]] = atom1; + pitorsion_atom2[m][num_pitorsion[m]] = atom2; + pitorsion_atom3[m][num_pitorsion[m]] = atom3; + pitorsion_atom4[m][num_pitorsion[m]] = atom4; + pitorsion_atom5[m][num_pitorsion[m]] = atom5; + pitorsion_atom6[m][num_pitorsion[m]] = atom6; + num_pitorsion[m]++; + } + + if ((m = atom->map(atom2)) >= 0) { + if (num_pitorsion[m] == PITORSIONMAX) + error->one(FLERR,"Too many PiTorsions for one atom"); + pitorsion_type[m][num_pitorsion[m]] = itype; + pitorsion_atom1[m][num_pitorsion[m]] = atom1; + pitorsion_atom2[m][num_pitorsion[m]] = atom2; + pitorsion_atom3[m][num_pitorsion[m]] = atom3; + pitorsion_atom4[m][num_pitorsion[m]] = atom4; + pitorsion_atom5[m][num_pitorsion[m]] = atom5; + pitorsion_atom6[m][num_pitorsion[m]] = atom6; + num_pitorsion[m]++; + } + if ((m = atom->map(atom3)) >= 0) { if (num_pitorsion[m] == PITORSIONMAX) error->one(FLERR,"Too many PiTorsions for one atom"); @@ -638,81 +719,45 @@ void FixPiTorsion::read_data_section(char *keyword, int n, char *buf, num_pitorsion[m]++; } - if (newton_bond == 0) { - if ((m = atom->map(atom1)) >= 0) { - if (num_pitorsion[m] == PITORSIONMAX) - error->one(FLERR,"Too many PiTorsions for one atom"); - pitorsion_type[m][num_pitorsion[m]] = itype; - pitorsion_atom1[m][num_pitorsion[m]] = atom1; - pitorsion_atom2[m][num_pitorsion[m]] = atom2; - pitorsion_atom3[m][num_pitorsion[m]] = atom3; - pitorsion_atom4[m][num_pitorsion[m]] = atom4; - pitorsion_atom5[m][num_pitorsion[m]] = atom5; - pitorsion_atom6[m][num_pitorsion[m]] = atom6; - num_pitorsion[m]++; - } + if ((m = atom->map(atom4)) >= 0) { + if (num_pitorsion[m] == PITORSIONMAX) + error->one(FLERR,"Too many PiTorsions for one atom"); + pitorsion_type[m][num_pitorsion[m]] = itype; + pitorsion_atom1[m][num_pitorsion[m]] = atom1; + pitorsion_atom2[m][num_pitorsion[m]] = atom2; + pitorsion_atom3[m][num_pitorsion[m]] = atom3; + pitorsion_atom4[m][num_pitorsion[m]] = atom4; + pitorsion_atom5[m][num_pitorsion[m]] = atom5; + pitorsion_atom6[m][num_pitorsion[m]] = atom6; + num_pitorsion[m]++; } - - if (newton_bond == 0) { - if ((m = atom->map(atom2)) >= 0) { - if (num_pitorsion[m] == PITORSIONMAX) - error->one(FLERR,"Too many PiTorsions for one atom"); - pitorsion_type[m][num_pitorsion[m]] = itype; - pitorsion_atom1[m][num_pitorsion[m]] = atom1; - pitorsion_atom2[m][num_pitorsion[m]] = atom2; - pitorsion_atom3[m][num_pitorsion[m]] = atom3; - pitorsion_atom4[m][num_pitorsion[m]] = atom4; - pitorsion_atom5[m][num_pitorsion[m]] = atom5; - pitorsion_atom6[m][num_pitorsion[m]] = atom6; - num_pitorsion[m]++; - } + + if ((m = atom->map(atom5)) >= 0) { + if (num_pitorsion[m] == PITORSIONMAX) + error->one(FLERR,"Too many PiTorsions for one atom"); + pitorsion_type[m][num_pitorsion[m]] = itype; + pitorsion_atom1[m][num_pitorsion[m]] = atom1; + pitorsion_atom2[m][num_pitorsion[m]] = atom2; + pitorsion_atom3[m][num_pitorsion[m]] = atom3; + pitorsion_atom4[m][num_pitorsion[m]] = atom4; + pitorsion_atom5[m][num_pitorsion[m]] = atom5; + pitorsion_atom6[m][num_pitorsion[m]] = atom6; + num_pitorsion[m]++; } - - if (newton_bond == 0) { - if ((m = atom->map(atom4)) >= 0) { - if (num_pitorsion[m] == PITORSIONMAX) - error->one(FLERR,"Too many PiTorsions for one atom"); - pitorsion_type[m][num_pitorsion[m]] = itype; - pitorsion_atom1[m][num_pitorsion[m]] = atom1; - pitorsion_atom2[m][num_pitorsion[m]] = atom2; - pitorsion_atom3[m][num_pitorsion[m]] = atom3; - pitorsion_atom4[m][num_pitorsion[m]] = atom4; - pitorsion_atom5[m][num_pitorsion[m]] = atom5; - pitorsion_atom6[m][num_pitorsion[m]] = atom6; - num_pitorsion[m]++; - } + + if ((m = atom->map(atom6)) >= 0) { + if (num_pitorsion[m] == PITORSIONMAX) + error->one(FLERR,"Too many PiTorsions for one atom"); + pitorsion_type[m][num_pitorsion[m]] = itype; + pitorsion_atom1[m][num_pitorsion[m]] = atom1; + pitorsion_atom2[m][num_pitorsion[m]] = atom2; + pitorsion_atom3[m][num_pitorsion[m]] = atom3; + pitorsion_atom4[m][num_pitorsion[m]] = atom4; + pitorsion_atom5[m][num_pitorsion[m]] = atom5; + pitorsion_atom6[m][num_pitorsion[m]] = atom6; + num_pitorsion[m]++; } - - if (newton_bond == 0) { - if ((m = atom->map(atom5)) >= 0) { - if (num_pitorsion[m] == PITORSIONMAX) - error->one(FLERR,"Too many PiTorsions for one atom"); - pitorsion_type[m][num_pitorsion[m]] = itype; - pitorsion_atom1[m][num_pitorsion[m]] = atom1; - pitorsion_atom2[m][num_pitorsion[m]] = atom2; - pitorsion_atom3[m][num_pitorsion[m]] = atom3; - pitorsion_atom4[m][num_pitorsion[m]] = atom4; - pitorsion_atom5[m][num_pitorsion[m]] = atom5; - pitorsion_atom6[m][num_pitorsion[m]] = atom6; - num_pitorsion[m]++; - } - } - - if (newton_bond == 0) { - if ((m = atom->map(atom6)) >= 0) { - if (num_pitorsion[m] == PITORSIONMAX) - error->one(FLERR,"Too many PiTorsions for one atom"); - pitorsion_type[m][num_pitorsion[m]] = itype; - pitorsion_atom1[m][num_pitorsion[m]] = atom1; - pitorsion_atom2[m][num_pitorsion[m]] = atom2; - pitorsion_atom3[m][num_pitorsion[m]] = atom3; - pitorsion_atom4[m][num_pitorsion[m]] = atom4; - pitorsion_atom5[m][num_pitorsion[m]] = atom5; - pitorsion_atom6[m][num_pitorsion[m]] = atom6; - num_pitorsion[m]++; - } - } - + buf = next + 1; } } @@ -750,7 +795,7 @@ void FixPiTorsion::write_data_section_size(int mth, int &nx, int &ny) // PiTorsions section // nx = # of PiTorsions owned by my local atoms - // if newton_bond off, atom only owns PiTorsion if it is atom3 + // only atom3 owns the PiTorsion in this context // ny = 7 columns = type + 6 atom IDs if (mth == 0) { diff --git a/src/AMOEBA/fix_pitorsion.h b/src/AMOEBA/fix_pitorsion.h index 7e3258c66a..718f6407d7 100644 --- a/src/AMOEBA/fix_pitorsion.h +++ b/src/AMOEBA/fix_pitorsion.h @@ -68,9 +68,11 @@ class FixPiTorsion : public Fix { int nprocs, me; int newton_bond, eflag_caller; int ilevel_respa; + int disable; bigint npitorsions; int npitorsion_types; double epitorsion; + double onesixth; double *kpit; diff --git a/src/AMOEBA/improper_amoeba.cpp b/src/AMOEBA/improper_amoeba.cpp index 0f6bb6705c..93a9b412cd 100644 --- a/src/AMOEBA/improper_amoeba.cpp +++ b/src/AMOEBA/improper_amoeba.cpp @@ -52,6 +52,8 @@ ImproperAmoeba::~ImproperAmoeba() void ImproperAmoeba::compute(int eflag, int vflag) { + if (disable) return; + int ia,ib,ic,id,n,type; double xia,yia,zia,xib,yib,zib,xic,yic,zic,xid,yid,zid; double xab,yab,zab,xcb,ycb,zcb,xdb,ydb,zdb,xad,yad,zad,xcd,ycd,zcd; @@ -63,9 +65,8 @@ void ImproperAmoeba::compute(int eflag, int vflag) double dccdxid,dccdyid,dccdzid; double deedxia,deedyia,deedzia,deedxic,deedyic,deedzic; double deedxid,deedyid,deedzid; - double eimproper,fa[3],fb[3],fc[3],fd[3]; + double fa[3],fb[3],fc[3],fd[3]; - eimproper = 0.0; ev_init(eflag,vflag); double **x = atom->x; @@ -152,7 +153,6 @@ void ImproperAmoeba::compute(int eflag, int vflag) dt4 = dt2 * dt2; e = prefactor * k[type] * dt2 * (1.0 + opbend_cubic*dt + opbend_quartic*dt2 + opbend_pentic*dt3 + opbend_sextic*dt4); - eimproper += e; deddt = k[type] * dt * (2.0 + 3.0*opbend_cubic*dt + 4.0*opbend_quartic*dt2 + @@ -285,6 +285,12 @@ void ImproperAmoeba::init_style() opbend_quartic = *(double *) pair->extract("opbend_quartic",dim); opbend_pentic = *(double *) pair->extract("opbend_pentic",dim); opbend_sextic = *(double *) pair->extract("opbend_sextic",dim); + + // check if PairAmoeba disabled improper terms + + int tmp; + int flag = *((int *) pair->extract("improper_flag",tmp)); + disable = flag ? 0 : 1; } /* ---------------------------------------------------------------------- diff --git a/src/AMOEBA/improper_amoeba.h b/src/AMOEBA/improper_amoeba.h index b25a60ac47..2c0cbaab6d 100644 --- a/src/AMOEBA/improper_amoeba.h +++ b/src/AMOEBA/improper_amoeba.h @@ -36,6 +36,7 @@ class ImproperAmoeba : public Improper { void write_data(FILE *); protected: + int disable; double opbend_cubic,opbend_quartic,opbend_pentic,opbend_sextic; double *k; diff --git a/src/AMOEBA/pair_amoeba.cpp b/src/AMOEBA/pair_amoeba.cpp index 474a764f22..446ca490a1 100644 --- a/src/AMOEBA/pair_amoeba.cpp +++ b/src/AMOEBA/pair_amoeba.cpp @@ -46,7 +46,9 @@ enum{MPOLE_GRID,POLAR_GRID,POLAR_GRIDC,DISP_GRID,INDUCE_GRID,INDUCE_GRIDC}; enum{MUTUAL,OPT,TCG,DIRECT}; enum{GEAR,ASPC,LSQR}; -#define DELTASTACK 1 // change this when debugged +#define DELTASTACK 16 + +#define UIND_DEBUG 0 // also in amoeba_induce.cpp /* ---------------------------------------------------------------------- */ @@ -226,9 +228,7 @@ PairAmoeba::~PairAmoeba() // DEBUG - if (me == 0) { - if (uind_flag) fclose(fp_uind); - } + if (me == 0 && UIND_DEBUG) fclose(fp_uind); } /* ---------------------------------------------------------------------- */ @@ -313,7 +313,7 @@ void PairAmoeba::compute(int eflag, int vflag) add_onefive_neighbors(); if (amoeba) find_hydrogen_neighbors(); find_multipole_neighbors(); - if (induce_flag && poltyp == MUTUAL && pcgprec) precond_neigh(); + if (poltyp == MUTUAL && pcgprec) precond_neigh(); } // reset KSpace recip matrix if box size/shape change dynamically @@ -377,18 +377,18 @@ void PairAmoeba::compute(int eflag, int vflag) // Ewald dispersion, pairwise and long range - if (hippo && disp_flag) dispersion(); + if (hippo && (disp_rspace_flag || disp_kspace_flag)) dispersion(); time4 = MPI_Wtime(); // multipole, pairwise and long range - if (mpole_flag) multipole(); + if (mpole_rspace_flag || mpole_kspace_flag) multipole(); time5 = MPI_Wtime(); // induced dipoles, interative CG relaxation // communicate induce() output values needed by ghost atoms - if (induce_flag) { + if (polar_rspace_flag || polar_kspace_flag) { induce(); cfstyle = INDUCE; comm->forward_comm_pair(this); @@ -397,7 +397,7 @@ void PairAmoeba::compute(int eflag, int vflag) // dipoles, pairwise and long range - if (polar_flag) polar(); + if (polar_rspace_flag || polar_kspace_flag) polar(); time7 = MPI_Wtime(); // charge transfer, pairwise @@ -522,49 +522,63 @@ void PairAmoeba::allocate() void PairAmoeba::settings(int narg, char **arg) { - // for now, allow turn on/off of individual FF terms - - // if (narg) error->all(FLERR,"Illegal pair_style command"); - // turn on all FF components by default - hal_flag = repulse_flag = disp_flag = induce_flag = - polar_flag = mpole_flag = qxfer_flag = 1; - rspace_flag = kspace_flag = 1; + hal_flag = repulse_flag = qxfer_flag = 1; + disp_rspace_flag = disp_kspace_flag = 1; + polar_rspace_flag = polar_kspace_flag = 1; + mpole_rspace_flag = mpole_kspace_flag = 1; + bond_flag = angle_flag = dihedral_flag = improper_flag = 1; + urey_flag = pitorsion_flag = xtorsion_flag = 1; - // turn off debug output by default + int newvalue = -1; - uind_flag = 0; + // include only specified FF components - // process optional args - // none turns all FF components off - - int iarg = 0; - while (iarg < narg) { - if (strcmp(arg[iarg],"none") == 0) { - hal_flag = repulse_flag = disp_flag = induce_flag = - polar_flag = mpole_flag = qxfer_flag = 0; - rspace_flag = kspace_flag = 0; - } - else if (strcmp(arg[iarg],"hal") == 0) hal_flag = 1; - else if (strcmp(arg[iarg],"repulse") == 0) repulse_flag = 1; - else if (strcmp(arg[iarg],"disp") == 0) disp_flag = 1; - else if (strcmp(arg[iarg],"induce") == 0) induce_flag = 1; - else if (strcmp(arg[iarg],"polar") == 0) polar_flag = 1; - else if (strcmp(arg[iarg],"mpole") == 0) mpole_flag = 1; - else if (strcmp(arg[iarg],"qxfer") == 0) qxfer_flag = 1; - - else if (strcmp(arg[iarg],"rspace") == 0) rspace_flag = 1; - else if (strcmp(arg[iarg],"kspace") == 0) kspace_flag = 1; - else if (strcmp(arg[iarg],"no-rspace") == 0) rspace_flag = 0; - else if (strcmp(arg[iarg],"no-kspace") == 0) kspace_flag = 0; + if (narg && (strcmp(arg[0],"include") == 0)) { + newvalue = 1; + hal_flag = repulse_flag = qxfer_flag = 0; + disp_rspace_flag = disp_kspace_flag = 0; + polar_rspace_flag = polar_kspace_flag = 0; + mpole_rspace_flag = mpole_kspace_flag = 0; + bond_flag = angle_flag = dihedral_flag = improper_flag = 0; + urey_flag = pitorsion_flag = xtorsion_flag = 0; - // DEBUG flags - - else if (strcmp(arg[iarg],"uind") == 0) uind_flag = 1; - + // exclude only specified FF components + + } else if (narg && (strcmp(arg[0],"exclude") == 0)) { + newvalue = 0; + + } else if (narg) error->all(FLERR,"Illegal pair_style command"); + + if (narg == 0) return; + + // toggle components to include or exclude + + for (int iarg = 1; iarg < narg; iarg++) { + if (strcmp(arg[iarg],"hal") == 0) hal_flag = newvalue; + else if (strcmp(arg[iarg],"repulse") == 0) repulse_flag = newvalue; + else if (strcmp(arg[iarg],"qxfer") == 0) qxfer_flag = newvalue; + else if (strcmp(arg[iarg],"disp") == 0) + disp_rspace_flag = disp_kspace_flag = newvalue; + else if (strcmp(arg[iarg],"disp/rspace") == 0) disp_rspace_flag = newvalue; + else if (strcmp(arg[iarg],"disp/kspace") == 0) disp_rspace_flag = newvalue; + else if (strcmp(arg[iarg],"polar") == 0) + polar_rspace_flag = polar_kspace_flag = newvalue; + else if (strcmp(arg[iarg],"polar/rspace") == 0) polar_rspace_flag = newvalue; + else if (strcmp(arg[iarg],"polar/kspace") == 0) polar_rspace_flag = newvalue; + else if (strcmp(arg[iarg],"mpole") == 0) + mpole_rspace_flag = mpole_kspace_flag = newvalue; + else if (strcmp(arg[iarg],"mpole/rspace") == 0) mpole_rspace_flag = newvalue; + else if (strcmp(arg[iarg],"mpole/kspace") == 0) mpole_rspace_flag = newvalue; + else if (strcmp(arg[iarg],"bond") == 0) bond_flag = newvalue; + else if (strcmp(arg[iarg],"angle") == 0) angle_flag = newvalue; + else if (strcmp(arg[iarg],"dihedral") == 0) dihedral_flag = newvalue; + else if (strcmp(arg[iarg],"improper") == 0) improper_flag = newvalue; + else if (strcmp(arg[iarg],"urey") == 0) urey_flag = newvalue; + else if (strcmp(arg[iarg],"pitorsion") == 0) pitorsion_flag = newvalue; + else if (strcmp(arg[iarg],"xtorsion") == 0) xtorsion_flag = newvalue; else error->all(FLERR,"Illegal pair_style command"); - iarg++; } } @@ -677,14 +691,9 @@ void PairAmoeba::init_style() //if (!force->special_onefive) // error->all(FLERR,"Pair style amoeba/hippo requires special_bonds one/five be set"); - // b/c induce computes fopt,foptp used by polar - - if (kspace_flag && optorder && polar_flag && !induce_flag) - error->all(FLERR,"Pair amoeba with optorder requires induce and polar together"); - // b/c polar uses mutipole virial terms - if (kspace_flag && apewald == aeewald && polar_flag && !mpole_flag) + if (apewald == aeewald && polar_kspace_flag && !mpole_kspace_flag) error->all(FLERR, "Pair amoeba with apewald = aeewald requires mpole and polar together"); @@ -979,7 +988,7 @@ void PairAmoeba::init_style() if (me == 0) { char fname[32]; sprintf(fname,"tmp.uind.kspace.%d",nprocs); - if (uind_flag) fp_uind = fopen(fname,"w"); + if (UIND_DEBUG) fp_uind = fopen(fname,"w"); } } @@ -1078,22 +1087,17 @@ double PairAmoeba::init_one(int i, int j) choose(REPULSE); cutoff = MAX(cutoff,sqrt(off2)); } - if (disp_flag) { + if (disp_rspace_flag || disp_kspace_flag) { if (use_dewald) choose(DISP_LONG); else choose(DISP); cutoff = MAX(cutoff,sqrt(off2)); } - if (mpole_flag) { + if (mpole_rspace_flag || mpole_kspace_flag) { if (use_ewald) choose(MPOLE_LONG); else choose(MPOLE); cutoff = MAX(cutoff,sqrt(off2)); } - if (induce_flag) { - if (use_ewald) choose(POLAR_LONG); - else choose(POLAR); - cutoff = MAX(cutoff,sqrt(off2)); - } - if (polar_flag) { + if (polar_rspace_flag || polar_kspace_flag) { if (use_ewald) choose(POLAR_LONG); else choose(POLAR); cutoff = MAX(cutoff,sqrt(off2)); @@ -2112,6 +2116,13 @@ void PairAmoeba::zero_energy_force_virial() void *PairAmoeba::extract(const char *str, int &dim) { dim = 0; + if (strcmp(str,"bond_flag") == 0) return (void *) &bond_flag; + if (strcmp(str,"angle_flag") == 0) return (void *) &angle_flag; + if (strcmp(str,"dihedral_flag") == 0) return (void *) &dihedral_flag; + if (strcmp(str,"improper_flag") == 0) return (void *) &improper_flag; + if (strcmp(str,"urey_flag") == 0) return (void *) &urey_flag; + if (strcmp(str,"pitorsion_flag") == 0) return (void *) &pitorsion_flag; + if (strcmp(str,"opbend_cubic") == 0) return (void *) &opbend_cubic; if (strcmp(str,"opbend_quartic") == 0) return (void *) &opbend_quartic; if (strcmp(str,"opbend_pentic") == 0) return (void *) &opbend_pentic; diff --git a/src/AMOEBA/pair_amoeba.h b/src/AMOEBA/pair_amoeba.h index 607c261695..342e0c5205 100644 --- a/src/AMOEBA/pair_amoeba.h +++ b/src/AMOEBA/pair_amoeba.h @@ -75,12 +75,12 @@ class PairAmoeba : public Pair { // turn on/off components of force field - int hal_flag,repulse_flag,disp_flag,induce_flag,polar_flag,mpole_flag,qxfer_flag; - int rspace_flag,kspace_flag; - - // DEBUG flags - - int uind_flag; + int hal_flag,repulse_flag,qxfer_flag; + int disp_rspace_flag,disp_kspace_flag; + int polar_rspace_flag,polar_kspace_flag; + int mpole_rspace_flag,mpole_kspace_flag; + int bond_flag,angle_flag,dihedral_flag,improper_flag; + int urey_flag,pitorsion_flag,xtorsion_flag; // DEBUG timers diff --git a/src/CLASS2/bond_class2.cpp b/src/CLASS2/bond_class2.cpp index 1a4c525ac6..d056b2aea9 100644 --- a/src/CLASS2/bond_class2.cpp +++ b/src/CLASS2/bond_class2.cpp @@ -24,10 +24,10 @@ #include "neighbor.h" #include "comm.h" #include "force.h" +#include "pair.h" #include "memory.h" #include "error.h" - using namespace LAMMPS_NS; /* ---------------------------------------------------------------------- */ @@ -53,6 +53,8 @@ BondClass2::~BondClass2() void BondClass2::compute(int eflag, int vflag) { + if (disable) return; + int i1,i2,n,type; double delx,dely,delz,ebond,fbond; double rsq,r,dr,dr2,dr3,dr4,de_bond; @@ -155,6 +157,22 @@ void BondClass2::coeff(int narg, char **arg) if (count == 0) error->all(FLERR,"Incorrect args for bond coefficients"); } +/* ---------------------------------------------------------------------- */ + +void BondClass2::init_style() +{ + // check if PairAmoeba disabled bond terms + + Pair *pair = force->pair_match("amoeba",1,0); + + if (!pair) disable = 0; + else { + int tmp; + int flag = *((int *) pair->extract("bond_flag",tmp)); + disable = flag ? 0 : 1; + } +} + /* ---------------------------------------------------------------------- return an equilbrium bond length ------------------------------------------------------------------------- */ diff --git a/src/CLASS2/bond_class2.h b/src/CLASS2/bond_class2.h index 75c1d52c1f..d9f7cafedd 100644 --- a/src/CLASS2/bond_class2.h +++ b/src/CLASS2/bond_class2.h @@ -30,6 +30,7 @@ class BondClass2 : public Bond { virtual ~BondClass2(); virtual void compute(int, int); virtual void coeff(int, char **); + void init_style(); double equilibrium_distance(int); void write_restart(FILE *); virtual void read_restart(FILE *); @@ -39,6 +40,7 @@ class BondClass2 : public Bond { protected: double *r0, *k2, *k3, *k4; + int disable; void allocate(); }; diff --git a/src/EXTRA-MOLECULE/dihedral_fourier.cpp b/src/EXTRA-MOLECULE/dihedral_fourier.cpp index b88c866e7c..1dcbdf4563 100644 --- a/src/EXTRA-MOLECULE/dihedral_fourier.cpp +++ b/src/EXTRA-MOLECULE/dihedral_fourier.cpp @@ -24,12 +24,12 @@ #include "comm.h" #include "neighbor.h" #include "force.h" +#include "pair.h" #include "update.h" #include "math_const.h" #include "memory.h" #include "error.h" - using namespace LAMMPS_NS; using namespace MathConst; @@ -70,6 +70,8 @@ DihedralFourier::~DihedralFourier() void DihedralFourier::compute(int eflag, int vflag) { + if (disable) return; + int i1,i2,i3,i4,i,j,m,n,type; double vb1x,vb1y,vb1z,vb2x,vb2y,vb2z,vb3x,vb3y,vb3z,vb2xm,vb2ym,vb2zm; double edihedral,f1[3],f2[3],f3[3],f4[3]; @@ -327,13 +329,28 @@ void DihedralFourier::coeff(int narg, char **arg) if (count == 0) error->all(FLERR,"Incorrect args for dihedral coefficients"); } +/* ---------------------------------------------------------------------- */ + +void DihedralFourier::init_style() +{ + // check if PairAmoeba disabled dihedral terms + + Pair *pair = force->pair_match("amoeba",1,0); + + if (!pair) disable = 0; + else { + int tmp; + int flag = *((int *) pair->extract("dihedral_flag",tmp)); + disable = flag ? 0 : 1; + } +} + /* ---------------------------------------------------------------------- proc 0 writes out coeffs to restart file ------------------------------------------------------------------------- */ void DihedralFourier::write_restart(FILE *fp) { - fwrite(&nterms[1],sizeof(int),atom->ndihedraltypes,fp); for (int i = 1; i <= atom->ndihedraltypes; i++) { fwrite(k[i],sizeof(double),nterms[i],fp); diff --git a/src/EXTRA-MOLECULE/dihedral_fourier.h b/src/EXTRA-MOLECULE/dihedral_fourier.h index 557d4b5277..208cf2099f 100644 --- a/src/EXTRA-MOLECULE/dihedral_fourier.h +++ b/src/EXTRA-MOLECULE/dihedral_fourier.h @@ -30,6 +30,7 @@ class DihedralFourier : public Dihedral { virtual ~DihedralFourier(); virtual void compute(int, int); void coeff(int, char **); + void init_style(); void write_restart(FILE *); void read_restart(FILE *); void write_data(FILE *); @@ -39,6 +40,7 @@ class DihedralFourier : public Dihedral { int **multiplicity; int *nterms; int implicit, weightflag; + int disable; void allocate(); }; From 90b33a1a3af2b8d62b634a106ef1f36a398746f2 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Thu, 10 Mar 2022 16:41:58 -0700 Subject: [PATCH 084/585] changed bookkeeping of forces --- examples/amoeba/in.ubiquitin | 9 -- examples/amoeba/in.water_box.amoeba | 9 -- examples/amoeba/in.water_box.hippo | 9 -- examples/amoeba/in.water_dimer.amoeba | 9 -- examples/amoeba/in.water_dimer.hippo | 9 -- examples/amoeba/in.water_hexamer.amoeba | 9 -- examples/amoeba/in.water_hexamer.hippo | 9 -- src/AMOEBA/amoeba_charge_transfer.cpp | 13 +-- src/AMOEBA/amoeba_dispersion.cpp | 21 +++-- src/AMOEBA/amoeba_hal.cpp | 37 ++++---- src/AMOEBA/amoeba_multipole.cpp | 25 ++--- src/AMOEBA/amoeba_polar.cpp | 45 ++++----- src/AMOEBA/amoeba_repulsion.cpp | 15 +-- src/AMOEBA/pair_amoeba.cpp | 119 +++++++----------------- src/AMOEBA/pair_amoeba.h | 4 +- 15 files changed, 116 insertions(+), 226 deletions(-) diff --git a/examples/amoeba/in.ubiquitin b/examples/amoeba/in.ubiquitin index 6f7d605af0..8603398ac0 100644 --- a/examples/amoeba/in.ubiquitin +++ b/examples/amoeba/in.ubiquitin @@ -38,15 +38,6 @@ compute virial all pressure NULL virial thermo_style custom step temp epair ebond eangle edihed eimp & emol etotal press c_virial[*] -# DEBUG: setup force components this way so can dump them - -fix fhal all store/state 0 fx fy fz -fix frepulse all store/state 0 fx fy fz -fix fdisp all store/state 0 fx fy fz -fix fpolar all store/state 0 fx fy fz -fix fmpole all store/state 0 fx fy fz -fix fqxfer all store/state 0 fx fy fz - # zero step run run 0 diff --git a/examples/amoeba/in.water_box.amoeba b/examples/amoeba/in.water_box.amoeba index da816783f7..961a81d8b4 100644 --- a/examples/amoeba/in.water_box.amoeba +++ b/examples/amoeba/in.water_box.amoeba @@ -33,15 +33,6 @@ compute virial all pressure NULL virial thermo_style custom step temp epair ebond eangle edihed eimp & emol etotal press c_virial[*] -# DEBUG: setup force components this way so can dump them - -fix fhal all store/state 0 fx fy fz -fix frepulse all store/state 0 fx fy fz -fix fdisp all store/state 0 fx fy fz -fix fpolar all store/state 0 fx fy fz -fix fmpole all store/state 0 fx fy fz -fix fqxfer all store/state 0 fx fy fz - # zero step run run 0 diff --git a/examples/amoeba/in.water_box.hippo b/examples/amoeba/in.water_box.hippo index 4c11bc66d0..5f8dc1efd3 100644 --- a/examples/amoeba/in.water_box.hippo +++ b/examples/amoeba/in.water_box.hippo @@ -33,15 +33,6 @@ compute virial all pressure NULL virial thermo_style custom step temp epair ebond eangle edihed eimp & emol etotal press c_virial[*] -# DEBUG: setup force components this way so can dump them - -fix fhal all store/state 0 fx fy fz -fix frepulse all store/state 0 fx fy fz -fix fdisp all store/state 0 fx fy fz -fix fpolar all store/state 0 fx fy fz -fix fmpole all store/state 0 fx fy fz -fix fqxfer all store/state 0 fx fy fz - # zero step run run 0 diff --git a/examples/amoeba/in.water_dimer.amoeba b/examples/amoeba/in.water_dimer.amoeba index 1573f87df8..fbeded4837 100644 --- a/examples/amoeba/in.water_dimer.amoeba +++ b/examples/amoeba/in.water_dimer.amoeba @@ -33,15 +33,6 @@ compute virial all pressure NULL virial thermo_style custom step temp epair ebond eangle edihed eimp & emol etotal press c_virial[*] -# DEBUG: setup force components this way so can dump them - -fix fhal all store/state 0 fx fy fz -fix frepulse all store/state 0 fx fy fz -fix fdisp all store/state 0 fx fy fz -fix fpolar all store/state 0 fx fy fz -fix fmpole all store/state 0 fx fy fz -fix fqxfer all store/state 0 fx fy fz - # zero step run run 0 diff --git a/examples/amoeba/in.water_dimer.hippo b/examples/amoeba/in.water_dimer.hippo index c94900c929..59ff9cc5a7 100644 --- a/examples/amoeba/in.water_dimer.hippo +++ b/examples/amoeba/in.water_dimer.hippo @@ -33,15 +33,6 @@ compute virial all pressure NULL virial thermo_style custom step temp epair ebond eangle edihed eimp & emol etotal press c_virial[*] -# DEBUG: setup force components this way so can dump them - -fix fhal all store/state 0 fx fy fz -fix frepulse all store/state 0 fx fy fz -fix fdisp all store/state 0 fx fy fz -fix fpolar all store/state 0 fx fy fz -fix fmpole all store/state 0 fx fy fz -fix fqxfer all store/state 0 fx fy fz - # zero step run run 0 diff --git a/examples/amoeba/in.water_hexamer.amoeba b/examples/amoeba/in.water_hexamer.amoeba index b50d0f25df..5f02dbd41d 100644 --- a/examples/amoeba/in.water_hexamer.amoeba +++ b/examples/amoeba/in.water_hexamer.amoeba @@ -33,15 +33,6 @@ compute virial all pressure NULL virial thermo_style custom step temp epair ebond eangle edihed eimp & emol etotal press c_virial[*] -# DEBUG: setup force components this way so can dump them - -fix fhal all store/state 0 fx fy fz -fix frepulse all store/state 0 fx fy fz -fix fdisp all store/state 0 fx fy fz -fix fpolar all store/state 0 fx fy fz -fix fmpole all store/state 0 fx fy fz -fix fqxfer all store/state 0 fx fy fz - # zero step run run 0 diff --git a/examples/amoeba/in.water_hexamer.hippo b/examples/amoeba/in.water_hexamer.hippo index c3ece34c23..3ba2379326 100644 --- a/examples/amoeba/in.water_hexamer.hippo +++ b/examples/amoeba/in.water_hexamer.hippo @@ -33,15 +33,6 @@ compute virial all pressure NULL virial thermo_style custom step temp epair ebond eangle edihed eimp & emol etotal press c_virial[*] -# DEBUG: setup force components this way so can dump them - -fix fhal all store/state 0 fx fy fz -fix frepulse all store/state 0 fx fy fz -fix fdisp all store/state 0 fx fy fz -fix fpolar all store/state 0 fx fy fz -fix fmpole all store/state 0 fx fy fz -fix fqxfer all store/state 0 fx fy fz - # zero step run run 0 diff --git a/src/AMOEBA/amoeba_charge_transfer.cpp b/src/AMOEBA/amoeba_charge_transfer.cpp index b815d06f83..5a7ee5b877 100644 --- a/src/AMOEBA/amoeba_charge_transfer.cpp +++ b/src/AMOEBA/amoeba_charge_transfer.cpp @@ -57,6 +57,7 @@ void PairAmoeba::charge_transfer() // owned atoms double **x = atom->x; + double **f = atom->f; int nlocal = atom->nlocal; // neigh list @@ -138,12 +139,12 @@ void PairAmoeba::charge_transfer() // increment the total charge transfer energy and derivatives - fqxfer[i][0] -= frcx; - fqxfer[i][1] -= frcy; - fqxfer[i][2] -= frcz; - fqxfer[j][0] += frcx; - fqxfer[j][1] += frcy; - fqxfer[j][2] += frcz; + f[i][0] -= frcx; + f[i][1] -= frcy; + f[i][2] -= frcz; + f[j][0] += frcx; + f[j][1] += frcy; + f[j][2] += frcz; // increment the internal virial tensor components diff --git a/src/AMOEBA/amoeba_dispersion.cpp b/src/AMOEBA/amoeba_dispersion.cpp index d19bceb14a..adda139ab0 100644 --- a/src/AMOEBA/amoeba_dispersion.cpp +++ b/src/AMOEBA/amoeba_dispersion.cpp @@ -99,6 +99,7 @@ void PairAmoeba::dispersion_real() // owned atoms double **x = atom->x; + double **f = atom->f; int nlocal = atom->nlocal; // neigh list @@ -202,12 +203,12 @@ void PairAmoeba::dispersion_real() dedx = de * xr; dedy = de * yr; dedz = de * zr; - fdisp[i][0] += dedx; - fdisp[i][1] += dedy; - fdisp[i][2] += dedz; - fdisp[j][0] -= dedx; - fdisp[j][1] -= dedy; - fdisp[j][2] -= dedz; + f[i][0] += dedx; + f[i][1] += dedy; + f[i][2] += dedz; + f[j][0] -= dedx; + f[j][1] -= dedy; + f[j][2] -= dedz; // increment the internal virial tensor components @@ -270,6 +271,7 @@ void PairAmoeba::dispersion_kspace() // owned atoms double **x = atom->x; + double **f = atom->f; int nlocal = atom->nlocal; double volbox = domain->prd[0] * domain->prd[1] * domain->prd[2]; @@ -405,15 +407,14 @@ void PairAmoeba::dispersion_kspace() } fi = csix[iclass]; - fdisp[m][0] += fi * (recip[0][0]*de1 + recip[0][1]*de2 + recip[0][2]*de3); - fdisp[m][1] += fi * (recip[1][0]*de1 + recip[1][1]*de2 + recip[1][2]*de3); - fdisp[m][2] += fi * (recip[2][0]*de1 + recip[2][1]*de2 + recip[2][2]*de3); + f[m][0] += fi * (recip[0][0]*de1 + recip[0][1]*de2 + recip[0][2]*de3); + f[m][1] += fi * (recip[1][0]*de1 + recip[1][1]*de2 + recip[1][2]*de3); + f[m][2] += fi * (recip[2][0]*de1 + recip[2][1]*de2 + recip[2][2]*de3); } // account for the energy and virial correction terms term = csixpr * aewald*aewald*aewald / denom0; - if (me == 0) { edisp -= term; diff --git a/src/AMOEBA/amoeba_hal.cpp b/src/AMOEBA/amoeba_hal.cpp index 3cf69f2536..98cb3605b1 100644 --- a/src/AMOEBA/amoeba_hal.cpp +++ b/src/AMOEBA/amoeba_hal.cpp @@ -61,6 +61,7 @@ void PairAmoeba::hal() // owned atoms double **x = atom->x; + double **f = atom->f; int nlocal = atom->nlocal; // neigh list @@ -158,31 +159,31 @@ void PairAmoeba::hal() "ghost comm is too short"); if (i == iv) { - fhal[i][0] += dedx; - fhal[i][1] += dedy; - fhal[i][2] += dedz; + f[i][0] += dedx; + f[i][1] += dedy; + f[i][2] += dedz; } else { - fhal[i][0] += dedx*redi; - fhal[i][1] += dedy*redi; - fhal[i][2] += dedz*redi; - fhal[iv][0] += dedx*rediv; - fhal[iv][1] += dedy*rediv; - fhal[iv][2] += dedz*rediv; + f[i][0] += dedx*redi; + f[i][1] += dedy*redi; + f[i][2] += dedz*redi; + f[iv][0] += dedx*rediv; + f[iv][1] += dedy*rediv; + f[iv][2] += dedz*rediv; } if (j == jv) { - fhal[j][0] -= dedx; - fhal[j][1] -= dedy; - fhal[j][2] -= dedz; + f[j][0] -= dedx; + f[j][1] -= dedy; + f[j][2] -= dedz; } else { redj = kred[jclass]; redjv = 1.0 - redj; - fhal[j][0] -= dedx*redj; - fhal[j][1] -= dedy*redj; - fhal[j][2] -= dedz*redj; - fhal[jv][0] -= dedx*redjv; - fhal[jv][1] -= dedy*redjv; - fhal[jv][2] -= dedz*redjv; + f[j][0] -= dedx*redj; + f[j][1] -= dedy*redj; + f[j][2] -= dedz*redj; + f[jv][0] -= dedx*redjv; + f[jv][1] -= dedy*redjv; + f[jv][2] -= dedz*redjv; } // increment the internal virial tensor components diff --git a/src/AMOEBA/amoeba_multipole.cpp b/src/AMOEBA/amoeba_multipole.cpp index 894a1df835..3e976acbf3 100644 --- a/src/AMOEBA/amoeba_multipole.cpp +++ b/src/AMOEBA/amoeba_multipole.cpp @@ -509,18 +509,18 @@ void PairAmoeba::multipole_real() // increment force-based gradient and torque on first site - fmpole[i][0] += frcx; - fmpole[i][1] += frcy; - fmpole[i][2] += frcz; + f[i][0] += frcx; + f[i][1] += frcy; + f[i][2] += frcz; tq[i][0] += ttmi[0]; tq[i][1] += ttmi[1]; tq[i][2] += ttmi[2]; // increment force-based gradient and torque on second site - fmpole[j][0] -= frcx; - fmpole[j][1] -= frcy; - fmpole[j][2] -= frcz; + f[j][0] -= frcx; + f[j][1] -= frcy; + f[j][2] -= frcz; tq[j][0] += ttmk[0]; tq[j][1] += ttmk[1]; tq[j][2] += ttmk[2]; @@ -558,7 +558,7 @@ void PairAmoeba::multipole_real() // resolve site torques then increment forces and virial for (i = 0; i < nlocal; i++) { - torque2force(i,tq[i],fix,fiy,fiz,fmpole); + torque2force(i,tq[i],fix,fiy,fiz,f); iz = zaxis2local[i]; ix = xaxis2local[i]; @@ -637,6 +637,7 @@ void PairAmoeba::multipole_kspace() // owned atoms double **x = atom->x; + double **f = atom->f; int nlocal = atom->nlocal; double volbox = domain->prd[0] * domain->prd[1] * domain->prd[2]; @@ -806,12 +807,12 @@ void PairAmoeba::multipole_kspace() h1 = recip[0][0]*f1 + recip[0][1]*f2 + recip[0][2]*f3; // matvec? h2 = recip[1][0]*f1 + recip[1][1]*f2 + recip[1][2]*f3; h3 = recip[2][0]*f1 + recip[2][1]*f2 + recip[2][2]*f3; - fmpole[i][0] += h1; - fmpole[i][1] += h2; - fmpole[i][2] += h3; + f[i][0] += h1; + f[i][1] += h2; + f[i][2] += h3; } empole += 0.5*e; - //printf("mpole_force %g %g %g \n", fmpole[0][0], fmpole[0][1], fmpole[0][2]); + //printf("mpole_force %g %g %g \n", f[0][0], f[0][1], f[0][2]); // augment the permanent multipole virial contributions @@ -849,7 +850,7 @@ void PairAmoeba::multipole_kspace() cmp[i][7]*cphi[i][4] + cmp[i][9]*cphi[i][8] - cmp[i][7]*cphi[i][5] - cmp[i][8]*cphi[i][9]; - torque2force(i,tem,fix,fiy,fiz,fmpole); + torque2force(i,tem,fix,fiy,fiz,f); iz = zaxis2local[i]; ix = xaxis2local[i]; diff --git a/src/AMOEBA/amoeba_polar.cpp b/src/AMOEBA/amoeba_polar.cpp index 83a07caa2e..cac2492df1 100644 --- a/src/AMOEBA/amoeba_polar.cpp +++ b/src/AMOEBA/amoeba_polar.cpp @@ -68,6 +68,7 @@ void PairAmoeba::polar() // owned atoms double **x = atom->x; + double **f = atom->f; int nlocal = atom->nlocal; // set the energy unit conversion factor @@ -101,7 +102,7 @@ void PairAmoeba::polar() tep[1] = term * (diz*uix-dix*uiz); tep[2] = term * (dix*uiy-diy*uix); - torque2force(i,tep,fix,fiy,fiz,fpolar); + torque2force(i,tep,fix,fiy,fiz,f); iz = zaxis2local[i]; ix = xaxis2local[i]; @@ -277,6 +278,7 @@ void PairAmoeba::polar_real() pval = atom->dvector[index_pval]; double **x = atom->x; + double **f = atom->f; int nlocal = atom->nlocal; int nall = nlocal + atom->nghost; @@ -1138,12 +1140,12 @@ void PairAmoeba::polar_real() // increment force-based gradient on the interaction sites - fpolar[i][0] -= frcx; - fpolar[i][1] -= frcy; - fpolar[i][2] -= frcz; - fpolar[j][0] += frcx; - fpolar[j][1] += frcy; - fpolar[j][2] += frcz; + f[i][0] -= frcx; + f[i][1] -= frcy; + f[i][2] -= frcz; + f[j][0] += frcx; + f[j][1] += frcy; + f[j][2] += frcz; // increment the virial due to pairwise Cartesian forces @@ -1197,7 +1199,7 @@ void PairAmoeba::polar_real() qiyz*dufld[i][3] - qixz*dufld[i][4] + 2.0*qixy*(dufld[i][0]-dufld[i][2]) + (qiyy-qixx)*dufld[i][1]; - torque2force(i,tep,fix,fiy,fiz,fpolar); + torque2force(i,tep,fix,fiy,fiz,f); iz = zaxis2local[i]; ix = xaxis2local[i]; @@ -1280,6 +1282,7 @@ void PairAmoeba::polar_kspace() // owned atoms double **x = atom->x; + double **f = atom->f; int nlocal = atom->nlocal; double volbox = domain->prd[0] * domain->prd[1] * domain->prd[2]; @@ -1515,9 +1518,9 @@ void PairAmoeba::polar_kspace() h1 = recip[0][0]*f1 + recip[0][1]*f2 + recip[0][2]*f3; h2 = recip[1][0]*f1 + recip[1][1]*f2 + recip[1][2]*f3; h3 = recip[2][0]*f1 + recip[2][1]*f2 + recip[2][2]*f3; - fpolar[i][0] += h1; - fpolar[i][1] += h2; - fpolar[i][2] += h3; + f[i][0] += h1; + f[i][1] += h2; + f[i][2] += h3; } // set the potential to be the induced dipole average @@ -1604,7 +1607,7 @@ void PairAmoeba::polar_kspace() 2.0*(cmp[i][5]-cmp[i][4])*cphidp[i][7] + cmp[i][7]*cphidp[i][4] + cmp[i][9]*cphidp[i][8] - cmp[i][7]*cphidp[i][5] - cmp[i][8]*cphidp[i][9]; - torque2force(i,tep,fix,fiy,fiz,fpolar); + torque2force(i,tep,fix,fiy,fiz,f); iz = zaxis2local[i]; ix = xaxis2local[i]; @@ -1669,9 +1672,9 @@ void PairAmoeba::polar_kspace() h2 = recip[1][0]*f1 + recip[1][1]*f2 + recip[1][2]*f3; h3 = recip[2][0]*f1 + recip[2][1]*f2 + recip[2][2]*f3; - fpolar[i][0] += copm[k+m+1]*h1; - fpolar[i][1] += copm[k+m+1]*h2; - fpolar[i][2] += copm[k+m+1]*h3; + f[i][0] += copm[k+m+1]*h1; + f[i][1] += copm[k+m+1]*h2; + f[i][2] += copm[k+m+1]*h3; for (j = 1; j < 4; j++) { cphid[j] = 0.0; @@ -1759,9 +1762,9 @@ void PairAmoeba::polar_kspace() h1 = recip[0][0]*f1 + recip[0][1]*f2 + recip[0][2]*f3; h2 = recip[1][0]*f1 + recip[1][1]*f2 + recip[1][2]*f3; h3 = recip[2][0]*f1 + recip[2][1]*f2 + recip[2][2]*f3; - fpolar[i][0] += h1; - fpolar[i][1] += h2; - fpolar[i][2] += h3; + f[i][0] += h1; + f[i][1] += h2; + f[i][2] += h3; for (j = 1; j < 4; j++) { cphid[j] = 0.0; @@ -1835,9 +1838,9 @@ void PairAmoeba::polar_kspace() h1 = recip[0][0]*f1 + recip[0][1]*f2 + recip[0][2]*f3; // matvec h2 = recip[1][0]*f1 + recip[1][1]*f2 + recip[1][2]*f3; h3 = recip[2][0]*f1 + recip[2][1]*f2 + recip[2][2]*f3; - fpolar[i][0] += h1; - fpolar[i][1] += h2; - fpolar[i][2] += h3; + f[i][0] += h1; + f[i][1] += h2; + f[i][2] += h3; for (j = 1; j < 4; j++) { cphid[j] = 0.0; diff --git a/src/AMOEBA/amoeba_repulsion.cpp b/src/AMOEBA/amoeba_repulsion.cpp index 11c4f821c2..2823a82de2 100644 --- a/src/AMOEBA/amoeba_repulsion.cpp +++ b/src/AMOEBA/amoeba_repulsion.cpp @@ -91,6 +91,7 @@ void PairAmoeba::repulsion() // owned atoms double **x = atom->x; + double **f = atom->f; int nlocal = atom->nlocal; // zero repulsion torque on owned + ghost atoms @@ -337,18 +338,18 @@ void PairAmoeba::repulsion() // increment force-based gradient and torque on atom I - frepulse[i][0] += frcx; - frepulse[i][1] += frcy; - frepulse[i][2] += frcz; + f[i][0] += frcx; + f[i][1] += frcy; + f[i][2] += frcz; tq[i][0] += ttri[0]; tq[i][1] += ttri[1]; tq[i][2] += ttri[2]; // increment force-based gradient and torque on atom J - frepulse[j][0] -= frcx; - frepulse[j][1] -= frcy; - frepulse[j][2] -= frcz; + f[j][0] -= frcx; + f[j][1] -= frcy; + f[j][2] -= frcz; tq[j][0] += ttrk[0]; tq[j][1] += ttrk[1]; tq[j][2] += ttrk[2]; @@ -389,7 +390,7 @@ void PairAmoeba::repulsion() // resolve site torques then increment forces and virial for (i = 0; i < nlocal; i++) { - torque2force(i,tq[i],fix,fiy,fiz,frepulse); + torque2force(i,tq[i],fix,fiy,fiz,f); iz = zaxis2local[i]; ix = xaxis2local[i]; diff --git a/src/AMOEBA/pair_amoeba.cpp b/src/AMOEBA/pair_amoeba.cpp index 446ca490a1..3c38eff7fe 100644 --- a/src/AMOEBA/pair_amoeba.cpp +++ b/src/AMOEBA/pair_amoeba.cpp @@ -247,9 +247,18 @@ void PairAmoeba::compute(int eflag, int vflag) evdwl = 0.0; ev_init(eflag,vflag); - // zero internal energy, force, virial terms + // zero energy/virial components - zero_energy_force_virial(); + ehal = erepulse = edisp = epolar = empole = eqxfer = 0.0; + + for (int i = 0; i < 6; i++) { + virhal[i] = 0.0; + virrepulse[i] = 0.0; + virdisp[i] = 0.0; + virpolar[i] = 0.0; + virmpole[i] = 0.0; + virqxfer[i] = 0.0; + } // grow local vectors and arrays if necessary @@ -414,15 +423,6 @@ void PairAmoeba::compute(int eflag, int vflag) nlocal = atom->nlocal; int nall = nlocal + atom->nghost; - for (int i = 0; i < nall; i++) { - f[i][0] = fhal[i][0] + frepulse[i][0] + fdisp[i][0] + - fmpole[i][0] + fpolar[i][0] + fqxfer[i][0]; - f[i][1] = fhal[i][1] + frepulse[i][1] + fdisp[i][1] + - fmpole[i][1] + fpolar[i][1] + fqxfer[i][1]; - f[i][2] = fhal[i][2] + frepulse[i][2] + fdisp[i][2] + - fmpole[i][2] + fpolar[i][2] + fqxfer[i][2]; - } - for (int i = 0; i < 6; i++) virial[i] = virhal[i] + virrepulse[i] + virdisp[i] + virpolar[i] + virmpole[i] + virqxfer[i]; @@ -553,6 +553,8 @@ void PairAmoeba::settings(int narg, char **arg) if (narg == 0) return; + if (narg < 2) error->all(FLERR,"Illegal pair_style command"); + // toggle components to include or exclude for (int iarg = 1; iarg < narg; iarg++) { @@ -728,19 +730,6 @@ void PairAmoeba::init_style() if (index_pval < 0 || !flag || cols) error->all(FLERR,"Pair amoeba pval is not defined"); - // check for fix store/state commands that stores force components - - ifhal = modify->find_fix("fhal"); - ifrepulse = modify->find_fix("frepulse"); - ifdisp = modify->find_fix("fdisp"); - ifpolar = modify->find_fix("fpolar"); - ifmpole = modify->find_fix("fmpole"); - ifqxfer = modify->find_fix("fqxfer"); - - if (ifhal < 0 || ifrepulse < 0 || ifdisp < 0 || - ifpolar < 0 || ifmpole < 0 || ifqxfer < 0) - error->all(FLERR,"Pair amoeba fix store/state commands not defined"); - // ------------------------------------------------------------------- // one-time initializations // can't do earlier b/c need all atoms to exist @@ -1079,33 +1068,26 @@ double PairAmoeba::init_one(int i, int j) { double cutoff = 0.0; - if (hal_flag) { - choose(VDWL); - cutoff = MAX(cutoff,sqrt(off2)); - } - if (repulse_flag) { - choose(REPULSE); - cutoff = MAX(cutoff,sqrt(off2)); - } - if (disp_rspace_flag || disp_kspace_flag) { - if (use_dewald) choose(DISP_LONG); - else choose(DISP); - cutoff = MAX(cutoff,sqrt(off2)); - } - if (mpole_rspace_flag || mpole_kspace_flag) { - if (use_ewald) choose(MPOLE_LONG); - else choose(MPOLE); - cutoff = MAX(cutoff,sqrt(off2)); - } - if (polar_rspace_flag || polar_kspace_flag) { - if (use_ewald) choose(POLAR_LONG); - else choose(POLAR); - cutoff = MAX(cutoff,sqrt(off2)); - } - if (qxfer_flag) { - choose(QFER); - cutoff = MAX(cutoff,sqrt(off2)); - } + choose(VDWL); + cutoff = MAX(cutoff,sqrt(off2)); + + choose(REPULSE); + cutoff = MAX(cutoff,sqrt(off2)); + + if (use_dewald) choose(DISP_LONG); + else choose(DISP); + cutoff = MAX(cutoff,sqrt(off2)); + + if (use_ewald) choose(MPOLE_LONG); + else choose(MPOLE); + cutoff = MAX(cutoff,sqrt(off2)); + + if (use_ewald) choose(POLAR_LONG); + else choose(POLAR); + cutoff = MAX(cutoff,sqrt(off2)); + + choose(QFER); + cutoff = MAX(cutoff,sqrt(off2)); return cutoff; } @@ -2076,41 +2058,6 @@ void PairAmoeba::mix() } } -/* ---------------------------------------------------------------------- - zero internal energy and virial terms -------------------------------------------------------------------------- */ - -void PairAmoeba::zero_energy_force_virial() -{ - ehal = erepulse = edisp = epolar = empole = eqxfer = 0.0; - - fhal = modify->fix[ifhal]->array_atom; - frepulse = modify->fix[ifrepulse]->array_atom; - fdisp = modify->fix[ifdisp]->array_atom; - fpolar = modify->fix[ifpolar]->array_atom; - fmpole = modify->fix[ifmpole]->array_atom; - fqxfer = modify->fix[ifqxfer]->array_atom; - - int nlocal = atom->nlocal; - int nall = nlocal + atom->nghost; - - memset(&fhal[0][0],0,3*nall*sizeof(double)); - memset(&frepulse[0][0],0,3*nall*sizeof(double)); - memset(&fdisp[0][0],0,3*nall*sizeof(double)); - memset(&fpolar[0][0],0,3*nall*sizeof(double)); - memset(&fmpole[0][0],0,3*nall*sizeof(double)); - memset(&fqxfer[0][0],0,3*nall*sizeof(double)); - - for (int i = 0; i < 6; i++) { - virhal[i] = 0.0; - virrepulse[i] = 0.0; - virdisp[i] = 0.0; - virpolar[i] = 0.0; - virmpole[i] = 0.0; - virqxfer[i] = 0.0; - } -} - /* ---------------------------------------------------------------------- */ void *PairAmoeba::extract(const char *str, int &dim) diff --git a/src/AMOEBA/pair_amoeba.h b/src/AMOEBA/pair_amoeba.h index 342e0c5205..7812395b07 100644 --- a/src/AMOEBA/pair_amoeba.h +++ b/src/AMOEBA/pair_amoeba.h @@ -87,11 +87,9 @@ class PairAmoeba : public Pair { double time_init,time_hal,time_repulse,time_disp; double time_mpole,time_induce,time_polar,time_qxfer; - // energy, force, and virial components + // energy/virial components - int ifhal,ifrepulse,ifdisp,ifpolar,ifmpole,ifqxfer; double ehal,erepulse,edisp,epolar,empole,eqxfer; - double **fhal,**frepulse,**fdisp,**fpolar,**fmpole,**fqxfer; double virhal[6],virrepulse[6],virdisp[6],virpolar[6],virmpole[6],virqxfer[6]; // scalar values defined in force-field file From f7f8deb70b3331b275e0a8812d185eeda5f0f30d Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Fri, 11 Mar 2022 07:24:18 -0700 Subject: [PATCH 085/585] amoeba vs hippo settings --- src/AMOEBA/pair_amoeba.cpp | 107 ++++++++++++++++++++++--------------- 1 file changed, 64 insertions(+), 43 deletions(-) diff --git a/src/AMOEBA/pair_amoeba.cpp b/src/AMOEBA/pair_amoeba.cpp index 3c38eff7fe..b28c0405a4 100644 --- a/src/AMOEBA/pair_amoeba.cpp +++ b/src/AMOEBA/pair_amoeba.cpp @@ -41,7 +41,7 @@ using namespace LAMMPS_NS; enum{INDUCE,RSD,SETUP_AMOEBA,SETUP_HIPPO,KMPOLE,AMGROUP,PVAL}; // forward comm enum{FIELD,ZRSD,TORQUE,UFLD}; // reverse comm enum{ARITHMETIC,GEOMETRIC,CUBIC_MEAN,R_MIN,SIGMA,DIAMETER,HARMONIC,HHG,W_H}; -enum{VDWL,REPULSE,QFER,DISP,MPOLE,POLAR,USOLV,DISP_LONG,MPOLE_LONG,POLAR_LONG}; +enum{HAL,REPULSE,QFER,DISP,MPOLE,POLAR,USOLV,DISP_LONG,MPOLE_LONG,POLAR_LONG}; enum{MPOLE_GRID,POLAR_GRID,POLAR_GRIDC,DISP_GRID,INDUCE_GRID,INDUCE_GRIDC}; enum{MUTUAL,OPT,TCG,DIRECT}; enum{GEAR,ASPC,LSQR}; @@ -481,20 +481,24 @@ void PairAmoeba::compute(int eflag, int vflag) utils::logmesg(lmp,"\nAMEOBA/HIPPO timing info:\n"); utils::logmesg(lmp," Init time: {:.6g} {:.6g}\n", time_init,time_init/time_amtot); - utils::logmesg(lmp," Hal time: {:.6g} {:.6g}\n", - time_hal,time_hal/time_amtot*100); - utils::logmesg(lmp," Repls time: {:.6g} {:.6g}\n", - time_repulse,time_repulse/time_amtot*100); - utils::logmesg(lmp," Disp time: {:.6g} {:.6g}\n", - time_disp,time_disp/time_amtot*100); + if (amoeba) + utils::logmesg(lmp," Hal time: {:.6g} {:.6g}\n", + time_hal,time_hal/time_amtot*100); + if (hippo) + utils::logmesg(lmp," Repls time: {:.6g} {:.6g}\n", + time_repulse,time_repulse/time_amtot*100); + if (hippo) + utils::logmesg(lmp," Disp time: {:.6g} {:.6g}\n", + time_disp,time_disp/time_amtot*100); utils::logmesg(lmp," Mpole time: {:.6g} {:.6g}\n", time_mpole,time_mpole/time_amtot*100); utils::logmesg(lmp," Induce time: {:.6g} {:.6g}\n", time_induce,time_induce/time_amtot*100); utils::logmesg(lmp," Polar time: {:.6g} {:.6g}\n", time_polar,time_polar/time_amtot*100); - utils::logmesg(lmp," Qxfer time: {:.6g} {:.6g}\n", - time_qxfer,time_qxfer/time_amtot*100); + if (hippo) + utils::logmesg(lmp," Qxfer time: {:.6g} {:.6g}\n", + time_qxfer,time_qxfer/time_amtot*100); utils::logmesg(lmp," Total time: {:.6g}\n\n",time_amtot); } } @@ -988,32 +992,41 @@ void PairAmoeba::init_style() void PairAmoeba::print_settings(FILE *fp) { fprintf(fp,"AMOEBA/HIPPO force field settings\n"); - choose(VDWL); - fprintf(fp," vdwl: cut %g taper %g vscale %g %g %g %g\n", - sqrt(off2),sqrt(cut2), - special_hal[1],special_hal[2],special_hal[3],special_hal[4]); + + if (amoeba) { + choose(HAL); + fprintf(fp," hal: cut %g taper %g vscale %g %g %g %g\n", + sqrt(off2),sqrt(cut2), + special_hal[1],special_hal[2],special_hal[3],special_hal[4]); + } + + if (hippo) { + choose(REPULSE); + fprintf(fp," repulsion: cut %g taper %g rscale %g %g %g %g\n", + sqrt(off2),sqrt(cut2), + special_repel[1],special_repel[2],special_repel[3],special_repel[4]); + } - choose(REPULSE); - fprintf(fp," repulsion: cut %g taper %g rscale %g %g %g %g\n", - sqrt(off2),sqrt(cut2), - special_repel[1],special_repel[2],special_repel[3],special_repel[4]); + if (hippo) { + choose(QFER); + fprintf(fp," qxfer: cut %g taper %g mscale %g %g %g %g\n", + sqrt(off2),sqrt(cut2), + special_mpole[1],special_mpole[2],special_mpole[3],special_mpole[4]); + } - choose(QFER); - fprintf(fp," qxfer: cut %g taper %g mscale %g %g %g %g\n", - sqrt(off2),sqrt(cut2), - special_mpole[1],special_mpole[2],special_mpole[3],special_mpole[4]); - - if (use_dewald) { - choose(DISP_LONG); - fprintf(fp," dispersion: cut %g aewald %g bsorder %d " - "FFT %d %d %d dspscale %g %g %g %g\n", - sqrt(off2),aewald,bsdorder,ndfft1,ndfft2,ndfft3, - special_disp[1],special_disp[2],special_disp[3],special_disp[4]); - } else { - choose(DISP); - fprintf(fp," dispersion: cut %g aewald %g dspscale %g %g %g %g\n", - sqrt(off2),aewald, - special_disp[1],special_disp[2],special_disp[3],special_disp[4]); + if (hippo) { + if (use_dewald) { + choose(DISP_LONG); + fprintf(fp," dispersion: cut %g aewald %g bsorder %d " + "FFT %d %d %d dspscale %g %g %g %g\n", + sqrt(off2),aewald,bsdorder,ndfft1,ndfft2,ndfft3, + special_disp[1],special_disp[2],special_disp[3],special_disp[4]); + } else { + choose(DISP); + fprintf(fp," dispersion: cut %g aewald %g dspscale %g %g %g %g\n", + sqrt(off2),aewald, + special_disp[1],special_disp[2],special_disp[3],special_disp[4]); + } } if (use_ewald) { @@ -1068,15 +1081,21 @@ double PairAmoeba::init_one(int i, int j) { double cutoff = 0.0; - choose(VDWL); - cutoff = MAX(cutoff,sqrt(off2)); + if (amoeba) { + choose(HAL); + cutoff = MAX(cutoff,sqrt(off2)); + } - choose(REPULSE); - cutoff = MAX(cutoff,sqrt(off2)); + if (hippo) { + choose(REPULSE); + cutoff = MAX(cutoff,sqrt(off2)); + } - if (use_dewald) choose(DISP_LONG); - else choose(DISP); - cutoff = MAX(cutoff,sqrt(off2)); + if (hippo) { + if (use_dewald) choose(DISP_LONG); + else choose(DISP); + cutoff = MAX(cutoff,sqrt(off2)); + } if (use_ewald) choose(MPOLE_LONG); else choose(MPOLE); @@ -1086,8 +1105,10 @@ double PairAmoeba::init_one(int i, int j) else choose(POLAR); cutoff = MAX(cutoff,sqrt(off2)); - choose(QFER); - cutoff = MAX(cutoff,sqrt(off2)); + if (hippo) { + choose(QFER); + cutoff = MAX(cutoff,sqrt(off2)); + } return cutoff; } @@ -1910,7 +1931,7 @@ void PairAmoeba::choose(int which) // short-range only terms - if (which == VDWL) { + if (which == HAL) { off = vdwcut; cut = vdwtaper; } else if (which == REPULSE) { From fd980e8fe0d14eedbff3ac9b232a54e072e6774b Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Fri, 11 Mar 2022 11:12:59 -0700 Subject: [PATCH 086/585] support for writing data files to fix pitorsion --- src/AMOEBA/fix_pitorsion.cpp | 15 +++++++++++++++ 1 file changed, 15 insertions(+) diff --git a/src/AMOEBA/fix_pitorsion.cpp b/src/AMOEBA/fix_pitorsion.cpp index b474c34202..7679458a7f 100644 --- a/src/AMOEBA/fix_pitorsion.cpp +++ b/src/AMOEBA/fix_pitorsion.cpp @@ -812,8 +812,12 @@ void FixPiTorsion::write_data_section_size(int mth, int &nx, int &ny) // PiTorsion Coeffs section // nx = # of PiTorsion types // ny = 2 columns = PiTorsion type + value + // only proc 0 returns a non-zero nx } else if (mth == 1) { + if (me == 0) nx = npitorsion_types; + else nx = 0; + ny = 2; } } @@ -853,8 +857,17 @@ void FixPiTorsion::write_data_section_pack(int mth, double **buf) // PiTorsion Coeffs section // 1st column = pitorsion type // 2nd column = value + // only proc 0 returns any data } else if (mth == 1) { + if (me) return; + + int n = 0; + for (i = 1; i <= npitorsion_types; i++) { + buf[n][0] = ubuf(i).d; + buf[n][1] = kpit[i]; + n += 2; + } } } @@ -893,6 +906,8 @@ void FixPiTorsion::write_data_section(int mth, FILE *fp, // PiTorsion Coeffs section } else if (mth == 1) { + for (int i = 0; i < n; i++) + fprintf(fp,"%d %g\n",(int) ubuf(buf[i][0]).i,buf[i][1]); } } From b48d35d3db9a5a795b88df306a475e9e03d8e438 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Mon, 14 Mar 2022 12:23:01 -0600 Subject: [PATCH 087/585] initial version of fix bitorsion --- src/AMOEBA/fix_bitorsion.cpp | 1135 ++++++++++++++++++++++++++++++++++ src/AMOEBA/fix_bitorsion.h | 136 ++++ src/AMOEBA/fix_pitorsion.cpp | 20 +- src/AMOEBA/fix_pitorsion.h | 2 +- src/AMOEBA/pair_amoeba.cpp | 7 +- src/AMOEBA/pair_amoeba.h | 2 +- 6 files changed, 1285 insertions(+), 17 deletions(-) create mode 100644 src/AMOEBA/fix_bitorsion.cpp create mode 100644 src/AMOEBA/fix_bitorsion.h diff --git a/src/AMOEBA/fix_bitorsion.cpp b/src/AMOEBA/fix_bitorsion.cpp new file mode 100644 index 0000000000..2fe63c08dd --- /dev/null +++ b/src/AMOEBA/fix_bitorsion.cpp @@ -0,0 +1,1135 @@ +// clang-format off +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + https://www.lammps.org/, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#include "fix_bitorsion.h" + +#include + +#include +#include "atom.h" +#include "update.h" +#include "respa.h" +#include "domain.h" +#include "force.h" +#include "pair.h" +#include "comm.h" +#include "math_const.h" +#include "memory.h" +#include "error.h" + +using namespace LAMMPS_NS; +using namespace FixConst; +using namespace MathConst; + +#define BITORSIONMAX 6 // max # of BiTorsion terms stored by one atom +#define LISTDELTA 10000 +#define LB_FACTOR 1.5 + +// NOTE: extra until figure things out + +int tnx(int k) { + return 0; +} +int tny(int k) { + return 0; +} +int ttx(int i, int j) { + return 0; +} +int tty(int i, int j) { + return 0; +} +int ttxy(int i,int j) { + return 0; +} +double tbf(int i,int j) { + return 0.0; +} +double tbx(int i,int j) { + return 0.0; +} +double tby(int i,int j) { + return 0.0; +} +double tbxy(int i,int j) { + return 0.0; +} + +void chkttor(int ib, int ic, int id, int sign, double value1, double value2) { +} + +void bcuint1(double *ftt, double *ft1, double *ft2, double *ft12, + double x1l, double x1u, double y1l, double y1u, + double value1, double value2, + double e, double dedang1, double dedang2) { +} + +/* ---------------------------------------------------------------------- */ + +FixBiTorsion::FixBiTorsion(LAMMPS *lmp, int narg, char **arg) : + Fix(lmp, narg, arg), + bitorsion_list(nullptr), num_bitorsion(nullptr), bitorsion_type(nullptr), + bitorsion_atom1(nullptr), bitorsion_atom2(nullptr), bitorsion_atom3(nullptr), + bitorsion_atom4(nullptr), bitorsion_atom5(nullptr) +{ + if (narg != 4) error->all(FLERR,"Illegal fix bitorsion command"); + + restart_global = 1; + restart_peratom = 1; + energy_global_flag = energy_peratom_flag = 1; + virial_global_flag = virial_peratom_flag = 1; + thermo_energy = thermo_virial = 1; + centroidstressflag = CENTROID_NOTAVAIL; + peratom_freq = 1; + scalar_flag = 1; + global_freq = 1; + extscalar = 1; + extvector = 1; + wd_header = 1; + wd_section = 1; + respa_level_support = 1; + ilevel_respa = 0; + + MPI_Comm_rank(world,&me); + MPI_Comm_size(world,&nprocs); + + // read and setup BiTorsion grid data + + read_grid_map(arg[3]); + + // perform initial allocation of atom-based arrays + + num_bitorsion = nullptr; + bitorsion_type = nullptr; + bitorsion_atom1 = nullptr; + bitorsion_atom2 = nullptr; + bitorsion_atom3 = nullptr; + bitorsion_atom4 = nullptr; + bitorsion_atom5 = nullptr; + + // register with Atom class + + nmax_previous = 0; + grow_arrays(atom->nmax); + atom->add_callback(Atom::GROW); + atom->add_callback(Atom::RESTART); + + // list of all bitorsions to compute on this proc + + nbitorsion_list = 0; + max_bitorsion_list = 0; + bitorsion_list = nullptr; +} + +/* --------------------------------------------------------------------- */ + +FixBiTorsion::~FixBiTorsion() +{ + // unregister callbacks to this fix from Atom class + + atom->delete_callback(id,Atom::GROW); + atom->delete_callback(id,Atom::RESTART); + + // per-atom data + + memory->destroy(num_bitorsion); + memory->destroy(bitorsion_type); + memory->destroy(bitorsion_atom1); + memory->destroy(bitorsion_atom2); + memory->destroy(bitorsion_atom3); + memory->destroy(bitorsion_atom4); + memory->destroy(bitorsion_atom5); + + // local list of bitorsions to compute + + memory->destroy(bitorsion_list); +} + +/* ---------------------------------------------------------------------- */ + +int FixBiTorsion::setmask() +{ + int mask = 0; + mask |= PRE_NEIGHBOR; + mask |= PRE_REVERSE; + mask |= POST_FORCE; + mask |= POST_FORCE_RESPA; + mask |= MIN_POST_FORCE; + return mask; +} + +/* ---------------------------------------------------------------------- */ + +void FixBiTorsion::init() +{ + if (utils::strmatch(update->integrate_style,"^respa")) { + ilevel_respa = ((Respa *) update->integrate)->nlevels-1; + if (respa_level >= 0) ilevel_respa = MIN(respa_level,ilevel_respa); + } + + // check if PairAmoeba disabled bitorsion terms + + Pair *pair = force->pair_match("amoeba",1,0); + + if (!pair) disable = 0; + else { + int tmp; + int flag = *((int *) pair->extract("bitorsion_flag",tmp)); + disable = flag ? 0 : 1; + } + + // constant + + onefifth = 0.2; +} + +/* --------------------------------------------------------------------- */ + +void FixBiTorsion::setup(int vflag) +{ + pre_neighbor(); + + if (utils::strmatch(update->integrate_style,"^verlet")) + post_force(vflag); + else { + ((Respa *) update->integrate)->copy_flevel_f(ilevel_respa); + post_force_respa(vflag,ilevel_respa,0); + ((Respa *) update->integrate)->copy_f_flevel(ilevel_respa); + } +} + +/* --------------------------------------------------------------------- */ + +void FixBiTorsion::setup_pre_neighbor() +{ + pre_neighbor(); +} + +/* --------------------------------------------------------------------- */ + +void FixBiTorsion::setup_pre_reverse(int eflag, int vflag) +{ + pre_reverse(eflag,vflag); +} + +/* --------------------------------------------------------------------- */ + +void FixBiTorsion::min_setup(int vflag) +{ + pre_neighbor(); + post_force(vflag); +} + +/* ---------------------------------------------------------------------- + create local list of bitorsions + if one or more atoms in bitorsion are on this proc, + this proc lists the bitorsion exactly once +------------------------------------------------------------------------- */ + +void FixBiTorsion::pre_neighbor() +{ + int i,m,atom1,atom2,atom3,atom4,atom5; + + // guesstimate initial length of local bitorsion list + // if nbitorsions was not set (due to read_restart, no read_data), + // then list will grow by LISTDELTA chunks + + if (max_bitorsion_list == 0) { + if (nprocs == 1) max_bitorsion_list = nbitorsions; + else max_bitorsion_list = + static_cast (LB_FACTOR*nbitorsions/nprocs); + memory->create(bitorsion_list,max_bitorsion_list,6, + "bitorsion:bitorsion_list"); + } + + int nlocal = atom->nlocal; + nbitorsion_list = 0; + + for (i = 0; i < nlocal; i++) { + for (m = 0; m < num_bitorsion[i]; m++) { + atom1 = atom->map(bitorsion_atom1[i][m]); + atom2 = atom->map(bitorsion_atom2[i][m]); + atom3 = atom->map(bitorsion_atom3[i][m]); + atom4 = atom->map(bitorsion_atom4[i][m]); + atom5 = atom->map(bitorsion_atom5[i][m]); + + if (atom1 == -1 || atom2 == -1 || atom3 == -1 || + atom4 == -1 || atom5 == -1) + error->one(FLERR,"BiTorsion atoms {} {} {} {} {} {} missing on " + "proc {} at step {}", + bitorsion_atom1[i][m],bitorsion_atom2[i][m], + bitorsion_atom3[i][m],bitorsion_atom4[i][m], + bitorsion_atom5[i][m],me,update->ntimestep); + atom1 = domain->closest_image(i,atom1); + atom2 = domain->closest_image(i,atom2); + atom3 = domain->closest_image(i,atom3); + atom4 = domain->closest_image(i,atom4); + atom5 = domain->closest_image(i,atom5); + + if (i <= atom1 && i <= atom2 && i <= atom3 && + i <= atom4 && i <= atom5) { + if (nbitorsion_list == max_bitorsion_list) { + max_bitorsion_list += LISTDELTA; + memory->grow(bitorsion_list,max_bitorsion_list,6, + "bitorsion:bitorsion_list"); + } + bitorsion_list[nbitorsion_list][0] = atom1; + bitorsion_list[nbitorsion_list][1] = atom2; + bitorsion_list[nbitorsion_list][2] = atom3; + bitorsion_list[nbitorsion_list][3] = atom4; + bitorsion_list[nbitorsion_list][4] = atom5; + bitorsion_list[nbitorsion_list][6] = bitorsion_type[i][m]; + nbitorsion_list++; + } + } + } +} + +/* ---------------------------------------------------------------------- + store eflag, so can use it in post_force to tally per-atom energies +------------------------------------------------------------------------- */ + +void FixBiTorsion::pre_reverse(int eflag, int /*vflag*/) +{ + eflag_caller = eflag; +} + +/* ---------------------------------------------------------------------- */ + +void FixBiTorsion::post_force(int vflag) +{ + if (disable) return; + + int ia,ib,ic,id,ie; + int nlo,nhi,nt; + int xlo,ylo; + int pos1,pos2; + double e,fgrp,sign; + double angle1,angle2; + double value1,value2; + double cosine1,cosine2; + double xt,yt,zt,rt2; + double xu,yu,zu,ru2; + double xv,yv,zv,rv2; + double rtru,rurv; + double x1l,x1u; + double y1l,y1u; + double xia,yia,zia; + double xib,yib,zib; + double xic,yic,zic; + double xid,yid,zid; + double xie,yie,zie; + double xba,yba,zba; + double xdc,ydc,zdc; + double xcb,ycb,zcb; + double xed,yed,zed; + double rcb,rdc; + double xca,yca,zca; + double xdb,ydb,zdb; + double xec,yec,zec; + double dedang1,dedang2; + double dedxt,dedyt,dedzt; + double dedxu,dedyu,dedzu; + double dedxu2,dedyu2,dedzu2; + double dedxv2,dedyv2,dedzv2; + double dedxia,dedyia,dedzia; + double dedxib,dedyib,dedzib; + double dedxic,dedyic,dedzic; + double dedxid,dedyid,dedzid; + double dedxib2,dedyib2,dedzib2; + double dedxic2,dedyic2,dedzic2; + double dedxid2,dedyid2,dedzid2; + double dedxie2,dedyie2,dedzie2; + double vxx,vyy,vzz; + double vyx,vzx,vzy; + double vxx2,vyy2,vzz2; + double vyx2,vzx2,vzy2; + double ftt[4],ft12[4]; + double ft1[4],ft2[4]; + + // NOTE: extra until figure everything out + + int k,btype; + double radian; + double engfraction; + int nlist,list[6]; + double v[6]; + + // END of NOTE + + ebitorsion = 0.0; + int eflag = eflag_caller; + ev_init(eflag,vflag); + + double **x = atom->x; + double **f = atom->f; + int nlocal = atom->nlocal; + + for (int n = 0; n < nbitorsion_list; n++) { + + ia = bitorsion_list[n][0]; + ib = bitorsion_list[n][1]; + ic = bitorsion_list[n][2]; + id = bitorsion_list[n][3]; + ie = bitorsion_list[n][4]; + + // NOTE: is a btype ever needed, maybe as index into spline tables? + + btype = bitorsion_list[n][5]; + + xia = x[ia][0]; + yia = x[ia][1]; + zia = x[ia][2]; + xib = x[ib][0]; + yib = x[ib][1]; + zib = x[ib][2]; + xic = x[ic][0]; + yic = x[ic][1]; + zic = x[ic][2]; + xid = x[id][0]; + yid = x[id][1]; + zid = x[id][2]; + xie = x[ie][0]; + yie = x[ie][1]; + zie = x[ie][2]; + + xba = xib - xia; + yba = yib - yia; + zba = zib - zia; + xcb = xic - xib; + ycb = yic - yib; + zcb = zic - zib; + xdc = xid - xic; + ydc = yid - yic; + zdc = zid - zic; + xed = xie - xid; + yed = yie - yid; + zed = zie - zid; + + xt = yba*zcb - ycb*zba; + yt = zba*xcb - zcb*xba; + zt = xba*ycb - xcb*yba; + xu = ycb*zdc - ydc*zcb; + yu = zcb*xdc - zdc*xcb; + zu = xcb*ydc - xdc*ycb; + + rt2 = xt*xt + yt*yt + zt*zt; + ru2 = xu*xu + yu*yu + zu*zu; + rtru = sqrt(rt2 * ru2); + xv = ydc*zed - yed*zdc; + yv = zdc*xed - zed*xdc; + zv = xdc*yed - xed*ydc; + rv2 = xv*xv + yv*yv + zv*zv; + rurv = sqrt(ru2 * rv2); + + if (rtru <= 0.0 || rurv <= 0.0) continue; + + rcb = sqrt(xcb*xcb + ycb*ycb + zcb*zcb); + cosine1 = (xt*xu + yt*yu + zt*zu) / rtru; + cosine1 = MIN(1.0,MAX(-1.0,cosine1)); + angle1 = radian * acos(cosine1); + sign = xba*xu + yba*yu + zba*zu; + if (sign < 0.0) angle1 = -angle1; + value1 = angle1; + + rdc = sqrt(xdc*xdc + ydc*ydc + zdc*zdc); + cosine2 = (xu*xv + yu*yv + zu*zv) / rurv; + cosine2 = MIN(1.0,MAX(-1.0,cosine2)); + angle2 = radian * acos(cosine2); + sign = xcb*xv + ycb*yv + zcb*zv; + if (sign < 0.0) angle2 = -angle2; + value2 = angle2; + + // check for inverted chirality at the central atom + + chkttor(ib,ic,id,sign,value1,value2); + + // use bicubic interpolation to compute spline values + // NOTE: need to worry about C vs Fortran indexing + // both here and in the methods called + // NOTE: make sure pos1 and pos2 are ints + + nlo = 1; + nhi = tnx(k); + while (nhi-nlo > 1) { + nt = (nhi+nlo) / 2; + if (ttx(nt,k) > value1) nhi = nt; + else nlo = nt; + } + + xlo = nlo; + nlo = 1; + nhi = tny(k); + while (nhi-nlo > 1) { + nt = (nhi + nlo)/2; + if (tty(nt,k) > value2) nhi = nt; + else nlo = nt; + } + + ylo = nlo; + x1l = ttx(xlo,k); + x1u = ttx(xlo+1,k); + y1l = tty(ylo,k); + y1u = tty(ylo+1,k); + pos2 = ylo*tnx(k) + xlo; + pos1 = pos2 - tnx(k); + + ftt[0] = tbf(pos1,k); + ftt[1] = tbf(pos1+1,k); + ftt[2] = tbf(pos2+1,k); + ftt[3] = tbf(pos2,k); + + ft1[0] = tbx(pos1,k); + ft1[1] = tbx(pos1+1,k); + ft1[2] = tbx(pos2+1,k); + ft1[3] = tbx(pos2,k); + + ft2[0] = tby(pos1,k); + ft2[1] = tby(pos1+1,k); + ft2[2] = tby(pos2+1,k); + ft2[3] = tby(pos2,k); + + ft12[0] = tbxy(pos1,k); + ft12[1] = tbxy(pos1+1,k); + ft12[2] = tbxy(pos2+1,k); + ft12[3] = tbxy(pos2,k); + + bcuint1(ftt,ft1,ft2,ft12,x1l,x1u,y1l,y1u,value1,value2, + e,dedang1,dedang2); + + // NOTE: remove ttorunit if 1.0 ? + // NOTE: what are radian units ? + // NOTE: value of sign is set twice above ?? + + double ttorunit = 1.0; + e *= ttorunit; + dedang1 = sign * ttorunit * radian * dedang1; + dedang2 = sign * ttorunit * radian * dedang2; + + // fraction of energy for each atom + + engfraction = e * onefifth; + + // chain rule terms for first angle derivative components + + xca = xic - xia; + yca = yic - yia; + zca = zic - zia; + xdb = xid - xib; + ydb = yid - yib; + zdb = zid - zib; + + dedxt = dedang1 * (yt*zcb - ycb*zt) / (rt2*rcb); + dedyt = dedang1 * (zt*xcb - zcb*xt) / (rt2*rcb); + dedzt = dedang1 * (xt*ycb - xcb*yt) / (rt2*rcb); + dedxu = -dedang1 * (yu*zcb - ycb*zu) / (ru2*rcb); + dedyu = -dedang1 * (zu*xcb - zcb*xu) / (ru2*rcb); + dedzu = -dedang1 * (xu*ycb - xcb*yu) / (ru2*rcb); + + // compute first derivative components for first angle + + dedxia = zcb*dedyt - ycb*dedzt; + dedyia = xcb*dedzt - zcb*dedxt; + dedzia = ycb*dedxt - xcb*dedyt; + dedxib = yca*dedzt - zca*dedyt + zdc*dedyu - ydc*dedzu; + dedyib = zca*dedxt - xca*dedzt + xdc*dedzu - zdc*dedxu; + dedzib = xca*dedyt - yca*dedxt + ydc*dedxu - xdc*dedyu; + dedxic = zba*dedyt - yba*dedzt + ydb*dedzu - zdb*dedyu; + dedyic = xba*dedzt - zba*dedxt + zdb*dedxu - xdb*dedzu; + dedzic = yba*dedxt - xba*dedyt + xdb*dedyu - ydb*dedxu; + dedxid = zcb*dedyu - ycb*dedzu; + dedyid = xcb*dedzu - zcb*dedxu; + dedzid = ycb*dedxu - xcb*dedyu; + + // chain rule terms for second angle derivative components + + xec = xie - xic; + yec = yie - yic; + zec = zie - zic; + + dedxu2 = dedang2 * (yu*zdc - ydc*zu) / (ru2*rdc); + dedyu2 = dedang2 * (zu*xdc - zdc*xu) / (ru2*rdc); + dedzu2 = dedang2 * (xu*ydc - xdc*yu) / (ru2*rdc); + dedxv2 = -dedang2 * (yv*zdc - ydc*zv) / (rv2*rdc); + dedyv2 = -dedang2 * (zv*xdc - zdc*xv) / (rv2*rdc); + dedzv2 = -dedang2 * (xv*ydc - xdc*yv) / (rv2*rdc); + + // compute first derivative components for second angle + + dedxib2 = zdc*dedyu2 - ydc*dedzu2; + dedyib2 = xdc*dedzu2 - zdc*dedxu2; + dedzib2 = ydc*dedxu2 - xdc*dedyu2; + dedxic2 = ydb*dedzu2 - zdb*dedyu2 + zed*dedyv2 - yed*dedzv2; + dedyic2 = zdb*dedxu2 - xdb*dedzu2 + xed*dedzv2 - zed*dedxv2; + dedzic2 = xdb*dedyu2 - ydb*dedxu2 + yed*dedxv2 - xed*dedyv2; + dedxid2 = zcb*dedyu2 - ycb*dedzu2 + yec*dedzv2 - zec*dedyv2; + dedyid2 = xcb*dedzu2 - zcb*dedxu2 + zec*dedxv2 - xec*dedzv2; + dedzid2 = ycb*dedxu2 - xcb*dedyu2 + xec*dedyv2 - yec*dedxv2; + dedxie2 = zdc*dedyv2 - ydc*dedzv2; + dedyie2 = xdc*dedzv2 - zdc*dedxv2; + dedzie2 = ydc*dedxv2 - xdc*dedyv2; + + // increment the torsion-torsion energy and gradient + + if (ia < nlocal) { + ebitorsion += engfraction; + f[ia][0] += dedxia; + f[ia][1] += dedyia; + f[ia][2] += dedzia; + } + + if (ib < nlocal) { + ebitorsion += engfraction; + f[ib][0] += dedxib + dedxib2; + f[ib][1] += dedyib + dedyib2; + f[ib][2] += dedzib + dedzib2; + } + + if (ic < nlocal) { + ebitorsion += engfraction; + f[ic][0] += dedxic + dedxic2; + f[ic][1] += dedyic + dedyic2; + f[ic][2] += dedzic + dedzic2; + } + + if (id < nlocal) { + ebitorsion += engfraction; + f[id][0] += dedxid + dedxid2; + f[id][1] += dedyid + dedyid2; + f[id][2] += dedzid + dedzid2; + } + + if (ie < nlocal) { + ebitorsion += engfraction; + f[ie][0] += dedxie2; + f[ie][1] += dedyie2; + f[ie][2] += dedzie2; + } + + // increment the internal virial tensor components + + if (evflag) { + nlist = 0; + if (ia < nlocal) list[nlist++] = ia; + if (ib < nlocal) list[nlist++] = ib; + if (ic < nlocal) list[nlist++] = ic; + if (id < nlocal) list[nlist++] = id; + if (ie < nlocal) list[nlist++] = ie; + + vxx = xcb*(dedxic+dedxid) - xba*dedxia + xdc*dedxid; + vyx = ycb*(dedxic+dedxid) - yba*dedxia + ydc*dedxid; + vzx = zcb*(dedxic+dedxid) - zba*dedxia + zdc*dedxid; + vyy = ycb*(dedyic+dedyid) - yba*dedyia + ydc*dedyid; + vzy = zcb*(dedyic+dedyid) - zba*dedyia + zdc*dedyid; + vzz = zcb*(dedzic+dedzid) - zba*dedzia + zdc*dedzid; + vxx2 = xdc*(dedxid2+dedxie2) - xcb*dedxib2 + xed*dedxie2; + vyx2 = ydc*(dedxid2+dedxie2) - ycb*dedxib2 + yed*dedxie2; + vzx2 = zdc*(dedxid2+dedxie2) - zcb*dedxib2 + zed*dedxie2; + vyy2 = ydc*(dedyid2+dedyie2) - ycb*dedyib2 + yed*dedyie2; + vzy2 = zdc*(dedyid2+dedyie2) - zcb*dedyib2 + zed*dedyie2; + vzz2 = zdc*(dedzid2+dedzie2) - zcb*dedzib2 + zed*dedzie2; + + v[0] += vxx + vxx2; + v[1] += vyy + vyy2; + v[2] += vzz + vzz2; + v[3] += vyx + vyx2; + v[4] += vzx + vzx2; + v[5] += vzy + vzy2; + + ev_tally(nlist,list,5.0,e,v); + } + } +} + +/* ---------------------------------------------------------------------- */ + +void FixBiTorsion::post_force_respa(int vflag, int ilevel, int /*iloop*/) +{ + if (ilevel == ilevel_respa) post_force(vflag); +} + +/* ---------------------------------------------------------------------- */ + +void FixBiTorsion::min_post_force(int vflag) +{ + post_force(vflag); +} + +/* ---------------------------------------------------------------------- + energy of BiTorision term +------------------------------------------------------------------------- */ + +double FixBiTorsion::compute_scalar() +{ + double all; + MPI_Allreduce(&ebitorsion,&all,1,MPI_DOUBLE,MPI_SUM,world); + return all; +} + +// ---------------------------------------------------------------------- +// ---------------------------------------------------------------------- +// methods to read BiTorsion potential file, perform interpolation +// ---------------------------------------------------------------------- +// ---------------------------------------------------------------------- + +void FixBiTorsion::read_grid_map(char *bitorsion_file) +{ + int MAXLINE = 1024; + char linebuf[MAXLINE]; + char *chunk,*line; + int i1, i2, i3, i4, i5, i6, j1, j2, j3, j4, j5, j6, counter; + + FILE *fp = nullptr; + if (me == 0) { + fp = utils::open_potential(bitorsion_file,lmp,nullptr); + if (fp == nullptr) + error->one(FLERR,"Cannot open fix cmap file {}: {}", + bitorsion_file, utils::getsyserror()); + + } + + int done; + + while (!done) { + // only read on rank 0 and broadcast to all other ranks + if (me == 0) + done = (fgets(linebuf,MAXLINE,fp) == nullptr); + + MPI_Bcast(&done,1,MPI_INT,0,world); + if (done) continue; + + MPI_Bcast(linebuf,MAXLINE,MPI_CHAR,0,world); + + // remove leading whitespace + line = linebuf; + while (line && (*line == ' ' || *line == '\t' || *line == '\r')) ++line; + + // skip if empty line or comment + if (!line || *line =='\n' || *line == '\0' || *line == '#') continue; + } + + if (me == 0) fclose(fp); +} + +// ---------------------------------------------------------------------- +// ---------------------------------------------------------------------- +// methods to read and write data file +// ---------------------------------------------------------------------- +// ---------------------------------------------------------------------- + +void FixBiTorsion::read_data_header(char *line) +{ + if (strstr(line,"bitorsions")) { + sscanf(line,BIGINT_FORMAT,&nbitorsions); + } else error->all(FLERR,"Invalid read data header line for fix bitorsion"); +} + +/* ---------------------------------------------------------------------- + unpack N lines in buf from section of data file labeled by keyword + id_offset is applied to atomID fields if multiple data files are read +------------------------------------------------------------------------- */ + +void FixBiTorsion::read_data_section(char *keyword, int n, char *buf, + tagint id_offset) +{ + int m,tmp,itype; + tagint atom1,atom2,atom3,atom4,atom5; + char *next; + + next = strchr(buf,'\n'); + *next = '\0'; + int nwords = utils::count_words(utils::trim_comment(buf)); + *next = '\n'; + + if (nwords != 7) + error->all(FLERR,"Incorrect {} format in data file",keyword); + + // loop over lines of BiTorsions + // tokenize the line into values + // each atom in the BiTorsion stores it + + for (int i = 0; i < n; i++) { + next = strchr(buf,'\n'); + *next = '\0'; + sscanf(buf,"%d %d " TAGINT_FORMAT " " TAGINT_FORMAT " " TAGINT_FORMAT + " " TAGINT_FORMAT " " TAGINT_FORMAT, + &tmp,&itype,&atom1,&atom2,&atom3,&atom4,&atom5); + + atom1 += id_offset; + atom2 += id_offset; + atom3 += id_offset; + atom4 += id_offset; + atom5 += id_offset; + + if ((m = atom->map(atom1)) >= 0) { + if (num_bitorsion[m] == BITORSIONMAX) + error->one(FLERR,"Too many BIORSIONS for one atom"); + bitorsion_type[m][num_bitorsion[m]] = itype; + bitorsion_atom1[m][num_bitorsion[m]] = atom1; + bitorsion_atom2[m][num_bitorsion[m]] = atom2; + bitorsion_atom3[m][num_bitorsion[m]] = atom3; + bitorsion_atom4[m][num_bitorsion[m]] = atom4; + bitorsion_atom5[m][num_bitorsion[m]] = atom5; + num_bitorsion[m]++; + } + + if ((m = atom->map(atom2)) >= 0) { + if (num_bitorsion[m] == BITORSIONMAX) + error->one(FLERR,"Too many BIORSIONS for one atom"); + bitorsion_type[m][num_bitorsion[m]] = itype; + bitorsion_atom1[m][num_bitorsion[m]] = atom1; + bitorsion_atom2[m][num_bitorsion[m]] = atom2; + bitorsion_atom3[m][num_bitorsion[m]] = atom3; + bitorsion_atom4[m][num_bitorsion[m]] = atom4; + bitorsion_atom5[m][num_bitorsion[m]] = atom5; + num_bitorsion[m]++; + } + + if ((m = atom->map(atom3)) >= 0) { + if (num_bitorsion[m] == BITORSIONMAX) + error->one(FLERR,"Too many BIORSIONS for one atom"); + bitorsion_type[m][num_bitorsion[m]] = itype; + bitorsion_atom1[m][num_bitorsion[m]] = atom1; + bitorsion_atom2[m][num_bitorsion[m]] = atom2; + bitorsion_atom3[m][num_bitorsion[m]] = atom3; + bitorsion_atom4[m][num_bitorsion[m]] = atom4; + bitorsion_atom5[m][num_bitorsion[m]] = atom5; + num_bitorsion[m]++; + } + + if ((m = atom->map(atom4)) >= 0) { + if (num_bitorsion[m] == BITORSIONMAX) + error->one(FLERR,"Too many BIORSIONS for one atom"); + bitorsion_type[m][num_bitorsion[m]] = itype; + bitorsion_atom1[m][num_bitorsion[m]] = atom1; + bitorsion_atom2[m][num_bitorsion[m]] = atom2; + bitorsion_atom3[m][num_bitorsion[m]] = atom3; + bitorsion_atom4[m][num_bitorsion[m]] = atom4; + bitorsion_atom5[m][num_bitorsion[m]] = atom5; + num_bitorsion[m]++; + } + + if ((m = atom->map(atom5)) >= 0) { + if (num_bitorsion[m] == BITORSIONMAX) + error->one(FLERR,"Too many BIORSIONS for one atom"); + bitorsion_type[m][num_bitorsion[m]] = itype; + bitorsion_atom1[m][num_bitorsion[m]] = atom1; + bitorsion_atom2[m][num_bitorsion[m]] = atom2; + bitorsion_atom3[m][num_bitorsion[m]] = atom3; + bitorsion_atom4[m][num_bitorsion[m]] = atom4; + bitorsion_atom5[m][num_bitorsion[m]] = atom5; + num_bitorsion[m]++; + } + + buf = next + 1; + } +} + +/* ---------------------------------------------------------------------- */ + +bigint FixBiTorsion::read_data_skip_lines(char * /*keyword*/) +{ + return nbitorsions; +} + +/* ---------------------------------------------------------------------- + write Mth header line to file + only called by proc 0 +------------------------------------------------------------------------- */ + +void FixBiTorsion::write_data_header(FILE *fp, int /*mth*/) +{ + fprintf(fp,BIGINT_FORMAT " bitorsions\n",nbitorsions); +} + +/* ---------------------------------------------------------------------- + return size I own for Mth data section + # of data sections = 1 for this fix + // nx = # of BiTorsions owned by my local atoms + // only atom3 owns the BiTorsion in this context + // ny = 6 columns = type + 5 atom IDs +------------------------------------------------------------------------- */ + +void FixBiTorsion::write_data_section_size(int /*mth*/, int &nx, int &ny) +{ + int i,m; + + tagint *tag = atom->tag; + int nlocal = atom->nlocal; + + nx = 0; + for (i = 0; i < nlocal; i++) + for (m = 0; m < num_bitorsion[i]; m++) + if (bitorsion_atom3[i][m] == tag[i]) nx++; + + ny = 6; +} + +/* ---------------------------------------------------------------------- + pack values for Mth data section into 2d buf + buf allocated by caller as owned BiTorsions by 6 +------------------------------------------------------------------------- */ + +void FixBiTorsion::write_data_section_pack(int /*mth*/, double **buf) +{ + int i,m; + + // 1st column = BiTorsion type + // 2nd-6th columns = 5 atom IDs + + tagint *tag = atom->tag; + int nlocal = atom->nlocal; + + int n = 0; + for (i = 0; i < nlocal; i++) { + for (m = 0; m < num_bitorsion[i]; m++) { + if (bitorsion_atom3[i][m] != tag[i]) continue; + buf[n][0] = ubuf(bitorsion_type[i][m]).d; + buf[n][1] = ubuf(bitorsion_atom1[i][m]).d; + buf[n][2] = ubuf(bitorsion_atom2[i][m]).d; + buf[n][3] = ubuf(bitorsion_atom3[i][m]).d; + buf[n][4] = ubuf(bitorsion_atom4[i][m]).d; + buf[n][5] = ubuf(bitorsion_atom5[i][m]).d; + n++; + } + } +} + +/* ---------------------------------------------------------------------- + write section keyword for Mth data section to file + use Molecules or Charges if that is only field, else use fix ID + only called by proc 0 +------------------------------------------------------------------------- */ + +void FixBiTorsion::write_data_section_keyword(int /*mth*/, FILE *fp) +{ + fprintf(fp,"\nBiTorsions\n\n"); +} + +/* ---------------------------------------------------------------------- + write N lines from buf to file + convert buf fields to int or double depending on styles + index can be used to prepend global numbering + only called by proc 0 +------------------------------------------------------------------------- */ + +void FixBiTorsion::write_data_section(int /*mth*/, FILE *fp, + int n, double **buf, int index) +{ + for (int i = 0; i < n; i++) + fprintf(fp,"%d %d " TAGINT_FORMAT " " TAGINT_FORMAT + " " TAGINT_FORMAT " " TAGINT_FORMAT " " TAGINT_FORMAT "\n", + index+i,(int) ubuf(buf[i][0]).i,(tagint) ubuf(buf[i][1]).i, + (tagint) ubuf(buf[i][2]).i,(tagint) ubuf(buf[i][3]).i, + (tagint) ubuf(buf[i][4]).i,(tagint) ubuf(buf[i][5]).i); +} + +// ---------------------------------------------------------------------- +// ---------------------------------------------------------------------- +// methods for restart and communication +// ---------------------------------------------------------------------- +// ---------------------------------------------------------------------- + +/* ---------------------------------------------------------------------- + pack entire state of Fix into one write +------------------------------------------------------------------------- */ + +void FixBiTorsion::write_restart(FILE *fp) +{ + if (comm->me == 0) { + int size = sizeof(bigint); + fwrite(&size,sizeof(int),1,fp); + fwrite(&nbitorsions,sizeof(bigint),1,fp); + } +} + +/* ---------------------------------------------------------------------- + use state info from restart file to restart the Fix +------------------------------------------------------------------------- */ + +void FixBiTorsion::restart(char *buf) +{ + nbitorsions = *((bigint *) buf); +} + +/* ---------------------------------------------------------------------- + pack values in local atom-based arrays for restart file +------------------------------------------------------------------------- */ + +int FixBiTorsion::pack_restart(int i, double *buf) +{ + int n = 1; + for (int m = 0; m < num_bitorsion[i]; m++) { + buf[n++] = ubuf(MAX(bitorsion_type[i][m],-bitorsion_type[i][m])).d; + buf[n++] = ubuf(bitorsion_atom1[i][m]).d; + buf[n++] = ubuf(bitorsion_atom2[i][m]).d; + buf[n++] = ubuf(bitorsion_atom3[i][m]).d; + buf[n++] = ubuf(bitorsion_atom4[i][m]).d; + buf[n++] = ubuf(bitorsion_atom5[i][m]).d; + } + buf[0] = n; + + return n; +} + +/* ---------------------------------------------------------------------- + unpack values from atom->extra array to restart the fix +------------------------------------------------------------------------- */ + +void FixBiTorsion::unpack_restart(int nlocal, int nth) +{ + double **extra = atom->extra; + + // skip to Nth set of extra values + // unpack the Nth first values this way because other fixes pack them + + int n = 0; + for (int i = 0; i < nth; i++) n += static_cast (extra[nlocal][n]); + + int count = static_cast (extra[nlocal][n++]); + num_bitorsion[nlocal] = (count-1)/6; + + for (int m = 0; m < num_bitorsion[nlocal]; m++) { + bitorsion_type[nlocal][m] = (int) ubuf(extra[nlocal][n++]).i; + bitorsion_atom1[nlocal][m] = (tagint) ubuf(extra[nlocal][n++]).i; + bitorsion_atom2[nlocal][m] = (tagint) ubuf(extra[nlocal][n++]).i; + bitorsion_atom3[nlocal][m] = (tagint) ubuf(extra[nlocal][n++]).i; + bitorsion_atom4[nlocal][m] = (tagint) ubuf(extra[nlocal][n++]).i; + bitorsion_atom5[nlocal][m] = (tagint) ubuf(extra[nlocal][n++]).i; + } +} + +/* ---------------------------------------------------------------------- + maxsize of any atom's restart data +------------------------------------------------------------------------- */ + +int FixBiTorsion::maxsize_restart() +{ + return 1 + BITORSIONMAX*6; +} + +/* ---------------------------------------------------------------------- + size of atom nlocal's restart data +------------------------------------------------------------------------- */ + +int FixBiTorsion::size_restart(int nlocal) +{ + return 1 + num_bitorsion[nlocal]*6; +} + +/* ---------------------------------------------------------------------- + allocate atom-based array +------------------------------------------------------------------------- */ + +void FixBiTorsion::grow_arrays(int nmax) +{ + num_bitorsion = memory->grow(num_bitorsion,nmax,"cmap:num_bitorsion"); + bitorsion_type = memory->grow(bitorsion_type,nmax,BITORSIONMAX, + "cmap:bitorsion_type"); + bitorsion_atom1 = memory->grow(bitorsion_atom1,nmax,BITORSIONMAX, + "cmap:bitorsion_atom1"); + bitorsion_atom2 = memory->grow(bitorsion_atom2,nmax,BITORSIONMAX, + "cmap:bitorsion_atom2"); + bitorsion_atom3 = memory->grow(bitorsion_atom3,nmax,BITORSIONMAX, + "cmap:bitorsion_atom3"); + bitorsion_atom4 = memory->grow(bitorsion_atom4,nmax,BITORSIONMAX, + "cmap:bitorsion_atom4"); + bitorsion_atom5 = memory->grow(bitorsion_atom5,nmax,BITORSIONMAX, + "cmap:bitorsion_atom5"); + + // must initialize num_bitorsion to 0 for added atoms + // may never be set for some atoms when data file is read + + for (int i = nmax_previous; i < nmax; i++) num_bitorsion[i] = 0; + nmax_previous = nmax; +} + +/* ---------------------------------------------------------------------- + copy values within local atom-based array +------------------------------------------------------------------------- */ + +void FixBiTorsion::copy_arrays(int i, int j, int /*delflag*/) +{ + num_bitorsion[j] = num_bitorsion[i]; + + for (int k = 0; k < num_bitorsion[j]; k++) { + bitorsion_type[j][k] = bitorsion_type[i][k]; + bitorsion_atom1[j][k] = bitorsion_atom1[i][k]; + bitorsion_atom2[j][k] = bitorsion_atom2[i][k]; + bitorsion_atom3[j][k] = bitorsion_atom3[i][k]; + bitorsion_atom4[j][k] = bitorsion_atom4[i][k]; + bitorsion_atom5[j][k] = bitorsion_atom5[i][k]; + } +} + +/* ---------------------------------------------------------------------- + initialize one atom's array values, called when atom is created +------------------------------------------------------------------------- */ + +void FixBiTorsion::set_arrays(int i) +{ + num_bitorsion[i] = 0; +} + +/* ---------------------------------------------------------------------- + pack values in local atom-based array for exchange with another proc +------------------------------------------------------------------------- */ + +int FixBiTorsion::pack_exchange(int i, double *buf) +{ + int n = 0; + buf[n++] = ubuf(num_bitorsion[i]).d; + for (int m = 0; m < num_bitorsion[i]; m++) { + buf[n++] = ubuf(bitorsion_type[i][m]).d; + buf[n++] = ubuf(bitorsion_atom1[i][m]).d; + buf[n++] = ubuf(bitorsion_atom2[i][m]).d; + buf[n++] = ubuf(bitorsion_atom3[i][m]).d; + buf[n++] = ubuf(bitorsion_atom4[i][m]).d; + buf[n++] = ubuf(bitorsion_atom5[i][m]).d; + } + return n; +} + +/* ---------------------------------------------------------------------- + unpack values in local atom-based array from exchange with another proc +------------------------------------------------------------------------- */ + +int FixBiTorsion::unpack_exchange(int nlocal, double *buf) +{ + int n = 0; + num_bitorsion[nlocal] = (int) ubuf(buf[n++]).i; + for (int m = 0; m < num_bitorsion[nlocal]; m++) { + bitorsion_type[nlocal][m] = (int) ubuf(buf[n++]).i; + bitorsion_atom1[nlocal][m] = (tagint) ubuf(buf[n++]).i; + bitorsion_atom2[nlocal][m] = (tagint) ubuf(buf[n++]).i; + bitorsion_atom3[nlocal][m] = (tagint) ubuf(buf[n++]).i; + bitorsion_atom4[nlocal][m] = (tagint) ubuf(buf[n++]).i; + bitorsion_atom5[nlocal][m] = (tagint) ubuf(buf[n++]).i; + } + return n; +} + +/* ---------------------------------------------------------------------- + memory usage of local atom-based arrays +------------------------------------------------------------------------- */ + +double FixBiTorsion::memory_usage() +{ + int nmax = atom->nmax; + double bytes = (double)nmax * sizeof(int); // num_bitorsion + bytes += (double)nmax*BITORSIONMAX * sizeof(int); // bitorsion_type + bytes += (double)5*nmax*BITORSIONMAX * sizeof(int); // bitorsion_atom 12345 + bytes += (double)6*max_bitorsion_list * sizeof(int); // bitorsion_list + return bytes; +} diff --git a/src/AMOEBA/fix_bitorsion.h b/src/AMOEBA/fix_bitorsion.h new file mode 100644 index 0000000000..0ed072f37c --- /dev/null +++ b/src/AMOEBA/fix_bitorsion.h @@ -0,0 +1,136 @@ +/* -*- c++ -*- ---------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + https://www.lammps.org/, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#ifdef FIX_CLASS +// clang-format off +FixStyle(bitorsion,FixBiTorsion); +// clang-format on +#else + +#ifndef LMP_FIX_BITORSION_H +#define LMP_FIX_BITORSION_H + +#include "fix.h" +namespace LAMMPS_NS { + +class FixBiTorsion : public Fix { + public: + FixBiTorsion(class LAMMPS *, int, char **); + ~FixBiTorsion(); + int setmask(); + void init(); + void setup(int); + void setup_pre_neighbor(); + void setup_pre_reverse(int, int); + void min_setup(int); + void pre_neighbor(); + void pre_reverse(int, int); + void post_force(int); + void post_force_respa(int, int, int); + void min_post_force(int); + double compute_scalar(); + + void read_data_header(char *); + void read_data_section(char *, int, char *, tagint); + bigint read_data_skip_lines(char *); + void write_data_header(FILE *, int); + void write_data_section_size(int, int &, int &); + void write_data_section_pack(int, double **); + void write_data_section_keyword(int, FILE *); + void write_data_section(int, FILE *, int, double **, int); + + void write_restart(FILE *); + void restart(char *); + int pack_restart(int, double *); + void unpack_restart(int, int); + int size_restart(int); + int maxsize_restart(); + + void grow_arrays(int); + void copy_arrays(int, int, int); + void set_arrays(int); + int pack_exchange(int, double *); + int unpack_exchange(int, double *); + + double memory_usage(); + + private: + int nprocs, me; + int eflag_caller; + int ilevel_respa; + int disable; + bigint nbitorsions; + double ebitorsion; + double onefifth; + + // per-atom data for bitorsions stored with each owned atom + + int *num_bitorsion; + int **bitorsion_type; + tagint **bitorsion_atom1, **bitorsion_atom2, **bitorsion_atom3; + tagint **bitorsion_atom4, **bitorsion_atom5; + + // previous max atoms on this proc before grow() is called + + int nmax_previous; + + // list of all bitorsions to compute on this proc + + int nbitorsion_list; + int max_bitorsion_list; + int **bitorsion_list; + + // read BiTorsion grid data + + void read_grid_map(char *); +}; +} // namespace LAMMPS_NS + +#endif +#endif + +/* ERROR/WARNING messages: + +E: Illegal ... command + +UNDOCUMENTED + +E: CMAP atoms %d %d %d %d %d missing on proc %d at step %ld + +UNDOCUMENTED + +E: Invalid CMAP crossterm_type + +UNDOCUMENTED + +E: Cannot open fix cmap file %s + +UNDOCUMENTED + +E: CMAP: atan2 function cannot take 2 zero arguments + +UNDOCUMENTED + +E: Invalid read data header line for fix cmap + +UNDOCUMENTED + +E: Incorrect %s format in data file + +UNDOCUMENTED + +E: Too many CMAP crossterms for one atom + +UNDOCUMENTED + +*/ diff --git a/src/AMOEBA/fix_pitorsion.cpp b/src/AMOEBA/fix_pitorsion.cpp index 7679458a7f..b66ffa0525 100644 --- a/src/AMOEBA/fix_pitorsion.cpp +++ b/src/AMOEBA/fix_pitorsion.cpp @@ -32,10 +32,11 @@ using namespace LAMMPS_NS; using namespace FixConst; using namespace MathConst; -#define PITORSIONMAX 6 +#define PITORSIONMAX 6 // max # of PiTorsion terms stored by one atom #define LISTDELTA 8196 #define LB_FACTOR 1.5 + /* ---------------------------------------------------------------------- */ FixPiTorsion::FixPiTorsion(LAMMPS *lmp, int narg, char **arg) : @@ -116,7 +117,7 @@ FixPiTorsion::~FixPiTorsion() memory->destroy(pitorsion_atom5); memory->destroy(pitorsion_atom6); - // compute list + // local list of bitorsions to compute memory->destroy(pitorsion_list); @@ -249,13 +250,6 @@ void FixPiTorsion::pre_neighbor() atom5 = domain->closest_image(i,atom5); atom6 = domain->closest_image(i,atom6); - /* - if (atom1 >= nlocal || atom2 >= nlocal || atom3 >= nlocal || - atom4 >= nlocal || atom5 >= nlocal || atom6 >= nlocal) - printf("ATOM 123456: %d %d %d %d %d %d\n", - atom1,atom2,atom3,atom4,atom5,atom6); - */ - if (i <= atom1 && i <= atom2 && i <= atom3 && i <= atom4 && i <= atom5 && i <= atom6) { if (npitorsion_list == max_pitorsion_list) { @@ -437,7 +431,7 @@ void FixPiTorsion::post_force(int vflag) dphi2 = 2.0 * (cosine2*s2 - sine2*c2); // calculate pi-system torsion energy and master chain rule term - // NOTE: remove ptornunit if 1.0 ? + // NOTE: remove ptorunit if 1.0 ? double ptorunit = 1.0; e = ptorunit * v2 * phi2; @@ -898,10 +892,12 @@ void FixPiTorsion::write_data_section(int mth, FILE *fp, if (mth == 0) { for (int i = 0; i < n; i++) fprintf(fp,"%d %d " TAGINT_FORMAT " " TAGINT_FORMAT - " " TAGINT_FORMAT " " TAGINT_FORMAT " " TAGINT_FORMAT "\n", + " " TAGINT_FORMAT " " TAGINT_FORMAT " " TAGINT_FORMAT + " " TAGINT_FORMAT "\n", index+i,(int) ubuf(buf[i][0]).i,(tagint) ubuf(buf[i][1]).i, (tagint) ubuf(buf[i][2]).i,(tagint) ubuf(buf[i][3]).i, - (tagint) ubuf(buf[i][4]).i,(tagint) ubuf(buf[i][5]).i); + (tagint) ubuf(buf[i][4]).i,(tagint) ubuf(buf[i][5]).i, + (tagint) ubuf(buf[i][6]).i); // PiTorsion Coeffs section diff --git a/src/AMOEBA/fix_pitorsion.h b/src/AMOEBA/fix_pitorsion.h index 718f6407d7..e335c6efa1 100644 --- a/src/AMOEBA/fix_pitorsion.h +++ b/src/AMOEBA/fix_pitorsion.h @@ -66,7 +66,7 @@ class FixPiTorsion : public Fix { private: int nprocs, me; - int newton_bond, eflag_caller; + int eflag_caller; int ilevel_respa; int disable; bigint npitorsions; diff --git a/src/AMOEBA/pair_amoeba.cpp b/src/AMOEBA/pair_amoeba.cpp index b28c0405a4..e64377d9b9 100644 --- a/src/AMOEBA/pair_amoeba.cpp +++ b/src/AMOEBA/pair_amoeba.cpp @@ -533,7 +533,7 @@ void PairAmoeba::settings(int narg, char **arg) polar_rspace_flag = polar_kspace_flag = 1; mpole_rspace_flag = mpole_kspace_flag = 1; bond_flag = angle_flag = dihedral_flag = improper_flag = 1; - urey_flag = pitorsion_flag = xtorsion_flag = 1; + urey_flag = pitorsion_flag = bitorsion_flag = 1; int newvalue = -1; @@ -546,7 +546,7 @@ void PairAmoeba::settings(int narg, char **arg) polar_rspace_flag = polar_kspace_flag = 0; mpole_rspace_flag = mpole_kspace_flag = 0; bond_flag = angle_flag = dihedral_flag = improper_flag = 0; - urey_flag = pitorsion_flag = xtorsion_flag = 0; + urey_flag = pitorsion_flag = bitorsion_flag = 0; // exclude only specified FF components @@ -583,7 +583,7 @@ void PairAmoeba::settings(int narg, char **arg) else if (strcmp(arg[iarg],"improper") == 0) improper_flag = newvalue; else if (strcmp(arg[iarg],"urey") == 0) urey_flag = newvalue; else if (strcmp(arg[iarg],"pitorsion") == 0) pitorsion_flag = newvalue; - else if (strcmp(arg[iarg],"xtorsion") == 0) xtorsion_flag = newvalue; + else if (strcmp(arg[iarg],"bitorsion") == 0) bitorsion_flag = newvalue; else error->all(FLERR,"Illegal pair_style command"); } } @@ -2090,6 +2090,7 @@ void *PairAmoeba::extract(const char *str, int &dim) if (strcmp(str,"improper_flag") == 0) return (void *) &improper_flag; if (strcmp(str,"urey_flag") == 0) return (void *) &urey_flag; if (strcmp(str,"pitorsion_flag") == 0) return (void *) &pitorsion_flag; + if (strcmp(str,"bitorsion_flag") == 0) return (void *) &bitorsion_flag; if (strcmp(str,"opbend_cubic") == 0) return (void *) &opbend_cubic; if (strcmp(str,"opbend_quartic") == 0) return (void *) &opbend_quartic; diff --git a/src/AMOEBA/pair_amoeba.h b/src/AMOEBA/pair_amoeba.h index 7812395b07..3925f72683 100644 --- a/src/AMOEBA/pair_amoeba.h +++ b/src/AMOEBA/pair_amoeba.h @@ -80,7 +80,7 @@ class PairAmoeba : public Pair { int polar_rspace_flag,polar_kspace_flag; int mpole_rspace_flag,mpole_kspace_flag; int bond_flag,angle_flag,dihedral_flag,improper_flag; - int urey_flag,pitorsion_flag,xtorsion_flag; + int urey_flag,pitorsion_flag,bitorsion_flag; // DEBUG timers From 1dda3055c23e663c56fca2a09b86ce0702f511c2 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Mon, 14 Mar 2022 14:31:03 -0600 Subject: [PATCH 088/585] enable tinker2lmp.py to generate bitorsions --- tools/tinker/tinker2lmp.py | 172 ++++++++++++++++++++++++++++++++++--- 1 file changed, 158 insertions(+), 14 deletions(-) diff --git a/tools/tinker/tinker2lmp.py b/tools/tinker/tinker2lmp.py index dfacebd832..b09ec6e031 100644 --- a/tools/tinker/tinker2lmp.py +++ b/tools/tinker/tinker2lmp.py @@ -7,6 +7,7 @@ # -amoeba file = AMOEBA PRM force field file name (required, or hippo) # -hippo file = HIPPO PRM force field file name (required, or amoeba) # -data file = LAMMPS data file to output (required) +# -bitorsion file = LAMMPS fix bitorsion file to output (required if BiTorsions) # -nopbc = non-periodic system (default) # -pbc xhi yhi zhi = periodic system from 0 to hi in each dimension (optional) @@ -31,6 +32,7 @@ def error(txt=""): print " -amoeba file" print " -hippo file" print " -data file" + print " -bitorsion file" print " -nopbc" print " -pbc xhi yhi zhi" else: print "ERROR:",txt @@ -108,6 +110,7 @@ class PRMfile: self.opbendparams = self.opbend() self.ureyparams = self.ureybonds() self.pitorsionparams = self.pitorsions() + self.bitorsionparams = self.bitorsions() self.ntypes = len(self.masses) # find a section in the PRM file @@ -329,10 +332,10 @@ class PRMfile: class4 = int(words[4]) if len(words) <= 5: - error("Torsion has no params: %d %d %d %d" % \ + error("torsion has no params: %d %d %d %d" % \ (class1,class2,class3,class4)) if (len(words)-5) % 3: - error("Torsion does not have triplets of params: %d %d %d %d" % \ + error("torsion does not have triplets of params: %d %d %d %d" % \ (class1,class2,class3,class4)) mfourier = (len(words)-5) / 3 @@ -399,7 +402,7 @@ class PRMfile: iline += 1 return params - # Pi Torsion params, will be read from data file by fix pitorsion + # PiTorsion params, will be read from data file by fix pitorsion def pitorsions(self): params = [] @@ -421,6 +424,43 @@ class PRMfile: iline += 1 return params + # BiTorsion params, will be read from data file by fix bitorsion + + def bitorsions(self): + params = [] + iline = self.find_section("Torsion-Torsion Parameters") + if iline < 0: return params + iline += 3 + + while iline < self.nlines: + words = self.lines[iline].split() + if len(words): + if words[0].startswith("###########"): break + if words[0] == "tortors": + class1 = int(words[1]) + class2 = int(words[2]) + class3 = int(words[3]) + class4 = int(words[4]) + class5 = int(words[5]) + nx = int(words[6]) + ny = int(words[7]) + iline += 1 + array = [] + for iy in range(ny): + xrow = [] + for ix in range(nx): + words = self.lines[iline].split() + xgrid = float(words[0]) + ygrid = float(words[1]) + value = float(words[2]) + tuple3 = (xgrid,ygrid,value) + xrow.append(tuple3) + iline += 1 + array.append(xrow) + params.append((class1,class2,class3,class4,class5,nx,ny,array)) + iline += 1 + return params + # ---------------------------------------- # main program # ---------------------------------------- @@ -434,6 +474,7 @@ amoeba = hippo = 0 xyzfile = "" prmfile = "" datafile = "" +bitorsionfile = "" pbcflag = 0 iarg = 0 @@ -456,6 +497,10 @@ while iarg < narg: if iarg + 2 > narg: error() datafile = args[iarg+1] iarg += 2 + elif args[iarg] == "-bitorsion": + if iarg + 2 > narg: error() + bitorsionfile = args[iarg+1] + iarg += 2 elif args[iarg] == "-nopbc": pbcflag = 0 iarg += 1 @@ -673,11 +718,7 @@ for atom1,atom2,atom3 in alist: elif (c3,c2,c1) in ubdict: ublist.append((atom3,atom2,atom1)) -# ---------------------------------------- -# create list of 6-body Pi-Torsion interactions -# ---------------------------------------- - -# create ptorslist = list of 6-body interactions +# create pitorslist = list of 6-body interactions # based on central bond, each bond atom is bonded to exactly 2 other atoms # avoid double counting by requiring atom1 < atom2 # NOTE: need more info on how to order the 6 atoms for Tinker to compute on @@ -716,9 +757,28 @@ for atom1 in id: pitorsionlist.append((atom3,atom4,atom1,atom2,atom5,atom6)) -# DEBUG - if uncommented, no PiTorsions appear in data file +# create bitorslist = list of 5-body interactions +# generate topology via double loop over neighbors of central atom3 +# additional double loop over bonds of atom2 and bonds of atom4 +# avoid double counting the reverse bitorsion by use of btdict dictionary -#pitorsionlist = [] +type = xyz.type +classes = prm.classes +bonds = xyz.bonds + +bitorsionlist = [] +btdict = {} + +for atom3 in id: + for atom2 in bonds[atom3-1]: + for atom4 in bonds[atom3-1]: + if atom2 == atom4: continue + for atom1 in bonds[atom2-1]: + for atom5 in bonds[atom4-1]: + if atom1 == atom3 or atom5 == atom3 or atom1 == atom5: continue + if (atom5,atom4,atom3,atom2,atom1) in btdict: continue + bitorsionlist.append((atom1,atom2,atom3,atom4,atom5)) + btdict[(atom1,atom2,atom3,atom4,atom5)] = 1 # ---------------------------------------- # create lists of bond/angle/dihedral/improper types @@ -752,7 +812,7 @@ for atom1,atom2 in blist: if (c1,c2) in bdict: m,params = bdict[(c1,c2)] elif (c2,c1) in bdict: m,params = bdict[(c2,c1)] - else: error("Bond not found: %d %d: %d %d" % (atom1,atom2,c1,c2)) + else: error("bond not found: %d %d: %d %d" % (atom1,atom2,c1,c2)) if not flags[m]: v1,v2,v3,v4 = params[2:] @@ -869,7 +929,7 @@ for i,one in enumerate(alist): m += 2 else: - error("Angle not found: %d %d %d: %d %d %d" % (atom1,atom2,atom3,c1,c2,c3)) + error("angle not found: %d %d %d: %d %d %d" % (atom1,atom2,atom3,c1,c2,c3)) if not flags[m]: pflag,ubflag,v1,v2,v3,v4,v5,v6 = params[3][which-1] @@ -979,7 +1039,7 @@ for atom1,atom2,atom3,atom4 in dlist: if (c1,c2,c3,c4) in ddict: m,params = ddict[(c1,c2,c3,c4)] elif (c4,c3,c2,c1) in ddict: m,params = ddict[(c4,c3,c2,c1)] else: - error("Dihedral not found: %d %d %d %d: %d %d %d %d" % \ + error("dihedral not found: %d %d %d %d: %d %d %d %d" % \ (atom1,atom2,atom3,atom4,c1,c2,c3,c4)) if not flags[m]: @@ -1063,7 +1123,7 @@ for tmp1,tmp2,atom1,atom2,tmp3,tmp4 in pitorsionlist: c1 = classes[type1-1] c2 = classes[type2-1] - # 6-tuple is only a PiTorsion if central 2 atoms math an entry in PRM file + # 6-tuple is only a PiTorsion if central 2 atoms match an entry in PRM file # pitorsionlist_reduced = list of just these 6-tuples if (c1,c2) in pitdict or (c2,c1) in pitdict: @@ -1081,6 +1141,57 @@ for tmp1,tmp2,atom1,atom2,tmp3,tmp4 in pitorsionlist: pitorsionlist = pitorsionlist_reduced +# generate bitorsiontype = LAMMPS type of each bitorsion +# generate bitorsionparams = LAMMPS params for each bitorsion type +# flags[i] = which LAMMPS bitorsion type (1-N) the Ith Tinker PRM file btors is +# 0 = none +# convert prm.bitorsionparams to a dictionary for efficient searching +# key = (class1,class2,class3,class4,class5) +# value = (M,params) where M is index into prm.bitorsionparams + +id = xyz.id +type = xyz.type +classes = prm.classes + +bitdict = {} +for m,params in enumerate(prm.bitorsionparams): + bitdict[(params[0],params[1],params[2],params[3],params[4])] = (m,params) + +flags = len(prm.bitorsionparams)*[0] +bitorsiontype = [] +bitorsionparams = [] +bitorsionlist_reduced = [] + +for atom1,atom2,atom3,atom4,atom5 in bitorsionlist: + type1 = type[atom1-1] + type2 = type[atom2-1] + type3 = type[atom3-1] + type4 = type[atom4-1] + type5 = type[atom5-1] + c1 = classes[type1-1] + c2 = classes[type2-1] + c3 = classes[type3-1] + c4 = classes[type4-1] + c5 = classes[type5-1] + + # 5-tuple is only a BiTorsion if 5 atoms match an entry in PRM file + # bitorsionlist_reduced = list of just these 5-tuples + + if (c1,c2,c3,c4,c5) in bitdict or (c5,c4,c3,c2,c1) in bitdict: + if (c1,c2,c3,c4,c5) in bitdict: m,params = bitdict[(c1,c2,c3,c4,c5)] + else: m,params = bitdict[(c5,c4,c3,c2,c1)] + bitorsionlist_reduced.append((atom1,atom2,atom3,atom4,atom5)) + + if not flags[m]: + v1 = params[5:] + bitorsionparams.append(v1) + flags[m] = len(bitorsionparams) + bitorsiontype.append(flags[m]) + +# replace original bitorsionlist with reduced version + +bitorsionlist = bitorsionlist_reduced + # ---------------------------------------- # assign each atom to a Tinker group # NOTE: doing this inside LAMMPS now @@ -1136,6 +1247,7 @@ nangles = len(alist) ndihedrals = len(dlist) nimpropers = len(olist) npitorsions = len(pitorsionlist) +nbitorsions = len(bitorsionlist) # data file header values @@ -1271,6 +1383,36 @@ if npitorsions: lines.append(line+'\n') d.sections["PiTorsions"] = lines +if nbitorsions: + d.headers["bitorsions"] = len(pitorsionlist) + + # if there are bitorsions, then -bitorsion file must have been specified + + if not bitorsionfile: + error("no -bitorsion file was specified, but %d bitorsions exist" % \ + nbitorsions) + + fp = open(bitorsionfile,'w') + print >>fp,"Tinker BiTorsion parameter file for fix bitorsion\n" + print >>fp,"%d bitorsion types" % len(bitorsionparams) + itype = 0 + for nx,ny,array in bitorsionparams: + itype += 1 + print >>fp + print >>fp,itype,nx,ny + for ix in range(nx): + for iy in range(ny): + xgrid,ygrid,value = array[ix][iy] + print >>fp," ",xgrid,ygrid,value + fp.close() + + lines = [] + for i,one in enumerate(bitorsionlist): + line = "%d %d %d %d %d %d %d" % \ + (i+1,bitorsiontype[i],one[0],one[1],one[2],one[3],one[4]) + lines.append(line+'\n') + d.sections["BiTorsions"] = lines + d.write(datafile) # print stats to screen @@ -1286,8 +1428,10 @@ print "Nangles =",nangles print "Ndihedrals =",ndihedrals print "Nimpropers =",nimpropers print "Npitorsions =",npitorsions +print "Nbitorsions =",nbitorsions print "Nbondtypes =",len(bparams) print "Nangletypes =",len(aparams) print "Ndihedraltypes =",len(dparams) print "Nimpropertypes =",len(oparams) print "Npitorsiontypes =",len(pitorsionparams) +print "Nbitorsiontypes =",len(bitorsionparams) From 1d86b3e270b5fe1735c4aecb167000e992d54def Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Mon, 14 Mar 2022 18:08:14 -0600 Subject: [PATCH 089/585] reading of bitorsion data file --- examples/amoeba/bitorsion.ubiquitin.data | 1884 ++++++++++++++++++++++ examples/amoeba/data.ubiquitin | 75 + examples/amoeba/in.ubiquitin | 4 +- src/AMOEBA/fix_bitorsion.cpp | 102 +- src/AMOEBA/fix_bitorsion.h | 8 +- src/modify.cpp | 2 +- 6 files changed, 2051 insertions(+), 24 deletions(-) create mode 100644 examples/amoeba/bitorsion.ubiquitin.data diff --git a/examples/amoeba/bitorsion.ubiquitin.data b/examples/amoeba/bitorsion.ubiquitin.data new file mode 100644 index 0000000000..5a59e1a16e --- /dev/null +++ b/examples/amoeba/bitorsion.ubiquitin.data @@ -0,0 +1,1884 @@ +Tinker BiTorsion parameter file for fix bitorsion + +3 bitorsion types + +1 25 25 + -180.0 -180.0 0.98936 + -165.0 -180.0 0.76408 + -150.0 -180.0 0.21674 + -135.0 -180.0 -0.182 + -120.0 -180.0 -0.37729 + -105.0 -180.0 -0.47834 + -90.0 -180.0 -0.59267 + -75.0 -180.0 -0.93985 + -60.0 -180.0 -1.55558 + -45.0 -180.0 -2.01849 + -30.0 -180.0 -1.94076 + -15.0 -180.0 -1.464 + 0.0 -180.0 0.18253 + 15.0 -180.0 -0.80364 + 30.0 -180.0 -1.32974 + 45.0 -180.0 -1.31658 + 60.0 -180.0 -0.5014 + 75.0 -180.0 0.20431 + 90.0 -180.0 0.39356 + 105.0 -180.0 0.20356 + 120.0 -180.0 -0.16993 + 135.0 -180.0 -0.22733 + 150.0 -180.0 0.13703 + 165.0 -180.0 0.66356 + 180.0 -180.0 0.98936 + -180.0 -165.0 0.96101 + -165.0 -165.0 0.37535 + -150.0 -165.0 -0.35733 + -135.0 -165.0 -0.69994 + -120.0 -165.0 -0.67298 + -105.0 -165.0 -0.58294 + -90.0 -165.0 -0.66465 + -75.0 -165.0 -1.02945 + -60.0 -165.0 -1.72427 + -45.0 -165.0 -2.19357 + -30.0 -165.0 -2.26378 + -15.0 -165.0 -1.7385 + 0.0 -165.0 -0.80969 + 15.0 -165.0 -1.16164 + 30.0 -165.0 -1.62772 + 45.0 -165.0 -1.51932 + 60.0 -165.0 -0.62569 + 75.0 -165.0 0.1313 + 90.0 -165.0 0.41019 + 105.0 -165.0 0.32974 + 120.0 -165.0 0.19191 + 135.0 -165.0 0.3232 + 150.0 -165.0 0.68257 + 165.0 -165.0 1.03015 + 180.0 -165.0 0.96101 + -180.0 -150.0 0.72651 + -165.0 -150.0 -0.04361 + -150.0 -150.0 -0.78147 + -135.0 -150.0 -0.90703 + -120.0 -150.0 -0.65095 + -105.0 -150.0 -0.48165 + -90.0 -150.0 -0.59657 + -75.0 -150.0 -1.14449 + -60.0 -150.0 -1.75396 + -45.0 -150.0 -2.279 + -30.0 -150.0 -2.14873 + -15.0 -150.0 -0.26757 + 0.0 -150.0 -0.77578 + 15.0 -150.0 -1.30595 + 30.0 -150.0 -1.79607 + 45.0 -150.0 -1.55982 + 60.0 -150.0 -0.57905 + 75.0 -150.0 0.30576 + 90.0 -150.0 0.70711 + 105.0 -150.0 0.68903 + 120.0 -150.0 0.53594 + 135.0 -150.0 0.60304 + 150.0 -150.0 0.88805 + 165.0 -150.0 0.9972 + 180.0 -150.0 0.72651 + -180.0 -135.0 0.155 + -165.0 -135.0 -0.20013 + -150.0 -135.0 -0.7966 + -135.0 -135.0 -0.74958 + -120.0 -135.0 -0.43624 + -105.0 -135.0 -0.36715 + -90.0 -135.0 -0.58938 + -75.0 -135.0 -0.99698 + -60.0 -135.0 -1.59208 + -45.0 -135.0 -1.67026 + -30.0 -135.0 0.50672 + -15.0 -135.0 -0.03293 + 0.0 -135.0 -0.84501 + 15.0 -135.0 -1.52731 + 30.0 -135.0 -1.89898 + 45.0 -135.0 -1.54469 + 60.0 -135.0 -0.53752 + 75.0 -135.0 0.40003 + 90.0 -135.0 0.88952 + 105.0 -135.0 0.8215 + 120.0 -135.0 0.58663 + 135.0 -135.0 0.56781 + 150.0 -135.0 0.74002 + 165.0 -135.0 0.84486 + 180.0 -135.0 0.155 + -180.0 -120.0 0.34021 + -165.0 -120.0 -0.20306 + -150.0 -120.0 -0.62787 + -135.0 -120.0 -0.55418 + -120.0 -120.0 -0.38986 + -105.0 -120.0 -0.44533 + -90.0 -120.0 -0.60179 + -75.0 -120.0 -0.93351 + -60.0 -120.0 -1.09198 + -45.0 -120.0 -0.18408 + -30.0 -120.0 1.24545 + -15.0 -120.0 -0.24279 + 0.0 -120.0 -1.24581 + 15.0 -120.0 -1.76363 + 30.0 -120.0 -1.8081 + 45.0 -120.0 -1.40319 + 60.0 -120.0 -0.63233 + 75.0 -120.0 0.15411 + 90.0 -120.0 0.5864 + 105.0 -120.0 0.51937 + 120.0 -120.0 0.25822 + 135.0 -120.0 0.13668 + 150.0 -120.0 0.23659 + 165.0 -120.0 0.46899 + 180.0 -120.0 0.34021 + -180.0 -105.0 -0.15437 + -165.0 -105.0 -0.1406 + -150.0 -105.0 -0.54321 + -135.0 -105.0 -0.58112 + -120.0 -105.0 -0.64967 + -105.0 -105.0 -0.71916 + -90.0 -105.0 -0.78801 + -75.0 -105.0 -0.76163 + -60.0 -105.0 -0.33401 + -45.0 -105.0 0.9172 + -30.0 -105.0 0.65423 + -15.0 -105.0 -0.84456 + 0.0 -105.0 -1.63476 + 15.0 -105.0 -1.65992 + 30.0 -105.0 -1.33178 + 45.0 -105.0 -1.08999 + 60.0 -105.0 -0.74243 + 75.0 -105.0 -0.33157 + 90.0 -105.0 -0.20618 + 105.0 -105.0 -0.07103 + 120.0 -105.0 -0.25941 + 135.0 -105.0 -0.37634 + 150.0 -105.0 -0.12892 + 165.0 -105.0 0.19386 + 180.0 -105.0 -0.15437 + -180.0 -90.0 0.4463 + -165.0 -90.0 0.02406 + -150.0 -90.0 -0.42821 + -135.0 -90.0 -0.76736 + -120.0 -90.0 -0.93537 + -105.0 -90.0 -0.86621 + -90.0 -90.0 -0.66178 + -75.0 -90.0 -0.23513 + -60.0 -90.0 0.41508 + -45.0 -90.0 0.97897 + -30.0 -90.0 -0.30358 + -15.0 -90.0 -1.42025 + 0.0 -90.0 -1.62146 + 15.0 -90.0 -0.98816 + 30.0 -90.0 -0.58148 + 45.0 -90.0 -0.49791 + 60.0 -90.0 -0.32045 + 75.0 -90.0 -0.39639 + 90.0 -90.0 -0.94422 + 105.0 -90.0 -0.74539 + 120.0 -90.0 -0.60241 + 135.0 -90.0 -0.56295 + 150.0 -90.0 -0.15877 + 165.0 -90.0 0.33609 + 180.0 -90.0 0.4463 + -180.0 -75.0 0.69562 + -165.0 -75.0 0.16403 + -150.0 -75.0 -0.43627 + -135.0 -75.0 -0.79169 + -120.0 -75.0 -0.80743 + -105.0 -75.0 -0.48767 + -90.0 -75.0 0.12397 + -75.0 -75.0 0.80972 + -60.0 -75.0 0.52616 + -45.0 -75.0 -0.13884 + -30.0 -75.0 -1.08459 + -15.0 -75.0 -1.556 + 0.0 -75.0 -1.12531 + 15.0 -75.0 -0.19831 + 30.0 -75.0 -0.00344 + 45.0 -75.0 0.01061 + 60.0 -75.0 0.11066 + 75.0 -75.0 -0.12406 + 90.0 -75.0 -0.8198 + 105.0 -75.0 -1.04369 + 120.0 -75.0 -0.62525 + 135.0 -75.0 -0.37223 + 150.0 -75.0 0.09012 + 165.0 -75.0 0.58855 + 180.0 -75.0 0.69562 + -180.0 -60.0 0.70531 + -165.0 -60.0 0.15456 + -150.0 -60.0 -0.40882 + -135.0 -60.0 -0.57653 + -120.0 -60.0 -0.20146 + -105.0 -60.0 0.21285 + -90.0 -60.0 0.15007 + -75.0 -60.0 0.06572 + -60.0 -60.0 -0.22861 + -45.0 -60.0 -0.75313 + -30.0 -60.0 -1.17725 + -15.0 -60.0 -1.0704 + 0.0 -60.0 -0.29306 + 15.0 -60.0 0.11777 + 30.0 -60.0 0.42905 + 45.0 -60.0 0.53679 + 60.0 -60.0 0.52038 + 75.0 -60.0 0.27617 + 90.0 -60.0 -0.36078 + 105.0 -60.0 -0.66569 + 120.0 -60.0 -0.35068 + 135.0 -60.0 -0.13164 + 150.0 -60.0 0.27666 + 165.0 -60.0 0.70865 + 180.0 -60.0 0.70531 + -180.0 -45.0 0.42237 + -165.0 -45.0 -0.14148 + -150.0 -45.0 -0.50856 + -135.0 -45.0 -0.14423 + -120.0 -45.0 -0.53339 + -105.0 -45.0 -0.514 + -90.0 -45.0 -0.3329 + -75.0 -45.0 -0.24488 + -60.0 -45.0 -0.32054 + -45.0 -45.0 -0.40379 + -30.0 -45.0 -0.41006 + -15.0 -45.0 -0.23372 + 0.0 -45.0 0.07185 + 15.0 -45.0 0.70729 + 30.0 -45.0 1.16881 + 45.0 -45.0 1.23276 + 60.0 -45.0 0.77518 + 75.0 -45.0 0.5197 + 90.0 -45.0 -0.12956 + 105.0 -45.0 -0.24028 + 120.0 -45.0 -0.08791 + 135.0 -45.0 0.02315 + 150.0 -45.0 0.32774 + 165.0 -45.0 0.5533 + 180.0 -45.0 0.42237 + -180.0 -30.0 0.127 + -165.0 -30.0 -0.36697 + -150.0 -30.0 -0.33178 + -135.0 -30.0 -1.09856 + -120.0 -30.0 -1.01098 + -105.0 -30.0 -0.6178 + -90.0 -30.0 -0.18232 + -75.0 -30.0 0.14143 + -60.0 -30.0 0.40819 + -45.0 -30.0 0.50556 + -30.0 -30.0 0.34379 + -15.0 -30.0 0.31224 + 0.0 -30.0 0.97008 + 15.0 -30.0 1.70616 + 30.0 -30.0 1.99942 + 45.0 -30.0 1.79196 + 60.0 -30.0 1.26978 + 75.0 -30.0 0.65732 + 90.0 -30.0 0.04223 + 105.0 -30.0 0.22658 + 120.0 -30.0 0.08209 + 135.0 -30.0 0.05525 + 150.0 -30.0 0.22382 + 165.0 -30.0 0.33964 + 180.0 -30.0 0.127 + -180.0 -15.0 -0.06517 + -165.0 -15.0 -0.13598 + -150.0 -15.0 -1.30614 + -135.0 -15.0 -1.09555 + -120.0 -15.0 -0.64991 + -105.0 -15.0 -0.06482 + -90.0 -15.0 0.49509 + -75.0 -15.0 0.92103 + -60.0 -15.0 1.94755 + -45.0 -15.0 0.95164 + -30.0 -15.0 0.8787 + -15.0 -15.0 1.42479 + 0.0 -15.0 2.06338 + 15.0 -15.0 2.50243 + 30.0 -15.0 2.59266 + 45.0 -15.0 2.02131 + 60.0 -15.0 1.26236 + 75.0 -15.0 0.65759 + 90.0 -15.0 0.60601 + 105.0 -15.0 0.40777 + 120.0 -15.0 0.08605 + 135.0 -15.0 -0.02333 + 150.0 -15.0 0.06947 + 165.0 -15.0 0.13044 + 180.0 -15.0 -0.06517 + -180.0 0.0 -1.44412 + -165.0 0.0 -1.37206 + -150.0 0.0 -0.97055 + -135.0 0.0 -0.54692 + -120.0 0.0 -0.04768 + -105.0 0.0 0.65462 + -90.0 0.0 1.09803 + -75.0 0.0 1.4118 + -60.0 0.0 1.23685 + -45.0 0.0 1.32368 + -30.0 0.0 1.83555 + -15.0 0.0 2.29146 + 0.0 0.0 2.61632 + 15.0 0.0 2.73204 + 30.0 0.0 2.49607 + 45.0 0.0 1.76205 + 60.0 0.0 1.23208 + 75.0 0.0 1.11843 + 90.0 0.0 1.50389 + 105.0 0.0 0.20088 + 120.0 0.0 -0.22667 + 135.0 0.0 -0.38306 + 150.0 0.0 -0.27813 + 165.0 0.0 -0.08165 + 180.0 0.0 -1.44412 + -180.0 15.0 -1.54337 + -165.0 15.0 -0.94875 + -150.0 15.0 -0.4463 + -135.0 15.0 -0.06444 + -120.0 15.0 0.39675 + -105.0 15.0 0.90513 + -90.0 15.0 1.24019 + -75.0 15.0 1.18954 + -60.0 15.0 1.36753 + -45.0 15.0 1.8229 + -30.0 15.0 2.22229 + -15.0 15.0 2.44694 + 0.0 15.0 2.44244 + 15.0 15.0 2.26164 + 30.0 15.0 1.85516 + 45.0 15.0 1.56722 + 60.0 15.0 1.43193 + 75.0 15.0 0.71918 + 90.0 15.0 0.14053 + 105.0 15.0 -0.36429 + 120.0 15.0 -0.76466 + 135.0 15.0 -0.87217 + 150.0 15.0 -0.57197 + 165.0 15.0 -1.61569 + 180.0 15.0 -1.54337 + -180.0 30.0 -1.09485 + -165.0 30.0 -0.56681 + -150.0 30.0 -0.13387 + -135.0 30.0 0.19412 + -120.0 30.0 0.57374 + -105.0 30.0 0.86366 + -90.0 30.0 0.80314 + -75.0 30.0 1.08125 + -60.0 30.0 1.39143 + -45.0 30.0 1.86048 + -30.0 30.0 2.01491 + -15.0 30.0 2.03904 + 0.0 30.0 1.77856 + 15.0 30.0 1.48754 + 30.0 30.0 1.53762 + 45.0 30.0 1.22766 + 60.0 30.0 0.55347 + 75.0 30.0 -0.06469 + 90.0 30.0 -0.47099 + 105.0 30.0 -0.82958 + 120.0 30.0 -1.01883 + 135.0 30.0 -0.75479 + 150.0 30.0 -1.39221 + 165.0 30.0 -1.55942 + 180.0 30.0 -1.09485 + -180.0 45.0 -0.55882 + -165.0 45.0 -0.22825 + -150.0 45.0 0.01795 + -135.0 45.0 0.21896 + -120.0 45.0 0.49238 + -105.0 45.0 0.39403 + -90.0 45.0 0.4887 + -75.0 45.0 0.90318 + -60.0 45.0 1.0673 + -45.0 45.0 1.40576 + -30.0 45.0 1.504 + -15.0 45.0 1.39328 + 0.0 45.0 1.13519 + 15.0 45.0 1.11176 + 30.0 45.0 0.55506 + 45.0 45.0 0.04408 + 60.0 45.0 -0.2593 + 75.0 45.0 -0.42888 + 90.0 45.0 -0.51963 + 105.0 45.0 -0.55634 + 120.0 45.0 -0.25212 + 135.0 45.0 -0.62098 + 150.0 45.0 -1.22694 + 165.0 45.0 -1.05054 + 180.0 45.0 -0.55882 + -180.0 60.0 -0.18285 + -165.0 60.0 -0.0865 + -150.0 60.0 0.00476 + -135.0 60.0 0.11545 + -120.0 60.0 0.16266 + -105.0 60.0 0.01161 + -90.0 60.0 0.39632 + -75.0 60.0 0.75519 + -60.0 60.0 0.96557 + -45.0 60.0 0.9764 + -30.0 60.0 0.97745 + -15.0 60.0 0.97978 + 0.0 60.0 0.79555 + 15.0 60.0 -0.15675 + 30.0 60.0 -0.51647 + 45.0 60.0 -0.39418 + 60.0 60.0 -0.15303 + 75.0 60.0 -0.008 + 90.0 60.0 0.09982 + 105.0 60.0 0.37002 + 120.0 60.0 0.12378 + 135.0 60.0 -0.63827 + 150.0 60.0 -0.59589 + 165.0 60.0 -0.38041 + 180.0 60.0 -0.18285 + -180.0 75.0 -0.066 + -165.0 75.0 -0.07528 + -150.0 75.0 -0.04119 + -135.0 75.0 -0.07933 + -120.0 75.0 -0.19424 + -105.0 75.0 -0.27213 + -90.0 75.0 0.0 + -75.0 75.0 0.40627 + -60.0 75.0 0.67141 + -45.0 75.0 0.48954 + -30.0 75.0 0.49392 + -15.0 75.0 0.53926 + 0.0 75.0 -0.43613 + 15.0 75.0 -0.91296 + 30.0 75.0 -0.57046 + 45.0 75.0 0.20602 + 60.0 75.0 0.66426 + 75.0 75.0 0.78486 + 90.0 75.0 0.83638 + 105.0 75.0 0.47569 + 120.0 75.0 -0.24156 + 135.0 75.0 -0.36935 + 150.0 75.0 -0.03276 + 165.0 75.0 -0.00079 + 180.0 75.0 -0.066 + -180.0 90.0 -0.19813 + -165.0 90.0 -0.18275 + -150.0 90.0 -0.13564 + -135.0 90.0 -0.16443 + -120.0 90.0 -0.25121 + -105.0 90.0 -0.36588 + -90.0 90.0 -0.30532 + -75.0 90.0 -0.05335 + -60.0 90.0 -0.11065 + -45.0 90.0 -0.24703 + -30.0 90.0 -0.35383 + -15.0 90.0 -0.66704 + 0.0 90.0 -1.22785 + 15.0 90.0 -0.99837 + 30.0 90.0 0.07165 + 45.0 90.0 1.1709 + 60.0 90.0 1.52568 + 75.0 90.0 1.19212 + 90.0 90.0 0.65821 + 105.0 90.0 0.07691 + 120.0 90.0 -0.25244 + 135.0 90.0 -0.10611 + 150.0 90.0 0.09358 + 165.0 90.0 0.00731 + 180.0 90.0 -0.19813 + -180.0 105.0 -0.3485 + -165.0 105.0 -0.15035 + -150.0 105.0 -0.40367 + -135.0 105.0 -0.01197 + -120.0 105.0 -0.061 + -105.0 105.0 -0.1519 + -90.0 105.0 -0.31715 + -75.0 105.0 -0.62391 + -60.0 105.0 -0.90231 + -45.0 105.0 -1.37607 + -30.0 105.0 -1.62179 + -15.0 105.0 -1.73579 + 0.0 105.0 -1.64875 + 15.0 105.0 -0.75542 + 30.0 105.0 0.71157 + 45.0 105.0 1.26356 + 60.0 105.0 0.7596 + 75.0 105.0 0.594 + 90.0 105.0 0.30667 + 105.0 105.0 -0.06284 + 120.0 105.0 -0.20456 + 135.0 105.0 -0.08836 + 150.0 105.0 -0.1659 + 165.0 105.0 -0.35505 + 180.0 105.0 -0.3485 + -180.0 120.0 -0.34576 + -165.0 120.0 0.02576 + -150.0 120.0 0.27228 + -135.0 120.0 0.28454 + -120.0 120.0 0.18375 + -105.0 120.0 0.01398 + -90.0 120.0 -0.27455 + -75.0 120.0 -0.7758 + -60.0 120.0 -1.42554 + -45.0 120.0 -1.99064 + -30.0 120.0 -2.37393 + -15.0 120.0 -2.20009 + 0.0 120.0 -1.60683 + 15.0 120.0 -0.44372 + 30.0 120.0 1.09513 + 45.0 120.0 0.35522 + 60.0 120.0 -0.04151 + 75.0 120.0 0.17766 + 90.0 120.0 0.14305 + 105.0 120.0 -0.13472 + 120.0 120.0 -0.31725 + 135.0 120.0 -0.458 + 150.0 120.0 -0.64821 + 165.0 120.0 -0.63355 + 180.0 120.0 -0.34576 + -180.0 135.0 -0.08457 + -165.0 135.0 0.36013 + -150.0 135.0 0.54446 + -135.0 135.0 0.48098 + -120.0 135.0 0.27776 + -105.0 135.0 0.02335 + -90.0 135.0 -0.28766 + -75.0 135.0 -0.80414 + -60.0 135.0 -1.5133 + -45.0 135.0 -2.20028 + -30.0 135.0 -2.36835 + -15.0 135.0 -2.12483 + 0.0 135.0 -1.376 + 15.0 135.0 -0.25291 + 30.0 135.0 0.78641 + 45.0 135.0 -0.96321 + 60.0 135.0 -0.57499 + 75.0 135.0 -0.00398 + 90.0 135.0 0.08668 + 105.0 135.0 -0.17475 + 120.0 135.0 -0.55212 + 135.0 135.0 -0.94225 + 150.0 135.0 -1.01661 + 165.0 135.0 -0.69656 + 180.0 135.0 -0.08457 + -180.0 150.0 0.2851 + -165.0 150.0 0.66185 + -150.0 150.0 0.69665 + -135.0 150.0 0.48378 + -120.0 150.0 0.16399 + -105.0 150.0 -0.09637 + -90.0 150.0 -0.36878 + -75.0 150.0 -0.80945 + -60.0 150.0 -1.41793 + -45.0 150.0 -2.18914 + -30.0 150.0 -2.20786 + -15.0 150.0 -1.82363 + 0.0 150.0 -1.11629 + 15.0 150.0 -0.04735 + 30.0 150.0 -1.17126 + 45.0 150.0 -1.34899 + 60.0 150.0 -0.62467 + 75.0 150.0 0.05642 + 90.0 150.0 0.17332 + 105.0 150.0 -0.14673 + 120.0 150.0 -0.698 + 135.0 150.0 -1.11306 + 150.0 150.0 -1.02621 + 165.0 150.0 -0.41495 + 180.0 150.0 0.2851 + -180.0 165.0 0.76902 + -165.0 165.0 0.89311 + -150.0 165.0 0.59358 + -135.0 165.0 0.25887 + -120.0 165.0 -0.03955 + -105.0 165.0 -0.24006 + -90.0 165.0 -0.46456 + -75.0 165.0 -0.8317 + -60.0 165.0 -1.40143 + -45.0 165.0 -1.95471 + -30.0 165.0 -2.00388 + -15.0 165.0 -1.56184 + 0.0 165.0 -0.83182 + 15.0 165.0 -0.45132 + 30.0 165.0 -1.23096 + 45.0 165.0 -1.2265 + 60.0 165.0 -0.44761 + 75.0 165.0 0.25891 + 90.0 165.0 0.39936 + 105.0 165.0 0.0765 + 120.0 165.0 -0.49787 + 135.0 165.0 -0.79017 + 150.0 165.0 -0.50914 + 165.0 165.0 0.18602 + 180.0 165.0 0.76902 + -180.0 180.0 0.98936 + -165.0 180.0 0.76408 + -150.0 180.0 0.21674 + -135.0 180.0 -0.182 + -120.0 180.0 -0.37729 + -105.0 180.0 -0.47834 + -90.0 180.0 -0.59267 + -75.0 180.0 -0.93985 + -60.0 180.0 -1.55558 + -45.0 180.0 -2.01849 + -30.0 180.0 -1.94076 + -15.0 180.0 -1.464 + 0.0 180.0 0.18253 + 15.0 180.0 -0.80364 + 30.0 180.0 -1.32974 + 45.0 180.0 -1.31658 + 60.0 180.0 -0.5014 + 75.0 180.0 0.20431 + 90.0 180.0 0.39356 + 105.0 180.0 0.20356 + 120.0 180.0 -0.16993 + 135.0 180.0 -0.22733 + 150.0 180.0 0.13703 + 165.0 180.0 0.66356 + 180.0 180.0 0.98936 + +2 25 25 + -180.0 -180.0 0.0 + -165.0 -180.0 -0.15918 + -150.0 -180.0 -0.46924 + -135.0 -180.0 -0.94887 + -120.0 -180.0 -1.41919 + -105.0 -180.0 -1.89608 + -90.0 -180.0 -2.35024 + -75.0 -180.0 -2.81648 + -60.0 -180.0 -3.17758 + -45.0 -180.0 -2.91092 + -30.0 -180.0 -1.84916 + -15.0 -180.0 -0.61868 + 0.0 -180.0 1.44957 + 15.0 -180.0 -0.61868 + 30.0 -180.0 -1.84916 + 45.0 -180.0 -2.91092 + 60.0 -180.0 -3.17758 + 75.0 -180.0 -2.81793 + 90.0 -180.0 -2.34954 + 105.0 -180.0 -1.91578 + 120.0 -180.0 -1.41919 + 135.0 -180.0 -0.94887 + 150.0 -180.0 -0.46924 + 165.0 -180.0 -0.15918 + 180.0 -180.0 0.0 + -180.0 -165.0 -0.03043 + -165.0 -165.0 -0.40282 + -150.0 -165.0 -0.84288 + -135.0 -165.0 -1.22723 + -120.0 -165.0 -1.58634 + -105.0 -165.0 -1.98317 + -90.0 -165.0 -2.46682 + -75.0 -165.0 -2.96238 + -60.0 -165.0 -3.27921 + -45.0 -165.0 -2.85897 + -30.0 -165.0 -1.66034 + -15.0 -165.0 0.28654 + 0.0 -165.0 0.47583 + 15.0 -165.0 -0.59328 + 30.0 -165.0 -1.85441 + 45.0 -165.0 -2.72832 + 60.0 -165.0 -2.82977 + 75.0 -165.0 -2.4375 + 90.0 -165.0 -1.97978 + 105.0 -165.0 -1.47132 + 120.0 -165.0 -0.94989 + 135.0 -165.0 -0.44166 + 150.0 -165.0 -0.04055 + 165.0 -165.0 0.10146 + 180.0 -165.0 -0.03043 + -180.0 -150.0 -0.05487 + -165.0 -150.0 -0.49639 + -150.0 -150.0 -0.83418 + -135.0 -150.0 -1.02443 + -120.0 -150.0 -1.24614 + -105.0 -150.0 -1.65671 + -90.0 -150.0 -2.17397 + -75.0 -150.0 -2.73078 + -60.0 -150.0 -2.95919 + -45.0 -150.0 -2.36553 + -30.0 -150.0 -0.65594 + -15.0 -150.0 1.60921 + 0.0 -150.0 0.68197 + 15.0 -150.0 -0.47503 + 30.0 -150.0 -1.60792 + 45.0 -150.0 -2.28172 + 60.0 -150.0 -2.27657 + 75.0 -150.0 -1.84368 + 90.0 -150.0 -1.32072 + 105.0 -150.0 -0.79693 + 120.0 -150.0 -0.27502 + 135.0 -150.0 0.15792 + 150.0 -150.0 0.37394 + 165.0 -150.0 0.30007 + 180.0 -150.0 -0.05487 + -180.0 -135.0 0.22137 + -165.0 -135.0 -0.11507 + -150.0 -135.0 -0.25069 + -135.0 -135.0 -0.2512 + -120.0 -135.0 -0.45372 + -105.0 -135.0 -0.91494 + -90.0 -135.0 -1.48283 + -75.0 -135.0 -1.97985 + -60.0 -135.0 -1.99291 + -45.0 -135.0 -0.87317 + -30.0 -135.0 2.15102 + -15.0 -135.0 2.08125 + 0.0 -135.0 1.01469 + 15.0 -135.0 -0.13409 + 30.0 -135.0 -1.08446 + 45.0 -135.0 -1.57764 + 60.0 -135.0 -1.54005 + 75.0 -135.0 -1.11846 + 90.0 -135.0 -0.54882 + 105.0 -135.0 -0.14353 + 120.0 -135.0 0.35059 + 135.0 -135.0 0.78961 + 150.0 -135.0 0.82176 + 165.0 -135.0 0.599 + 180.0 -135.0 0.22137 + -180.0 -120.0 0.76282 + -165.0 -120.0 0.65049 + -150.0 -120.0 0.73226 + -135.0 -120.0 0.80302 + -120.0 -120.0 0.46767 + -105.0 -120.0 -0.17578 + -90.0 -120.0 -0.55868 + -75.0 -120.0 -0.87022 + -60.0 -120.0 -0.44624 + -45.0 -120.0 1.42775 + -30.0 -120.0 3.49117 + -15.0 -120.0 2.47433 + 0.0 -120.0 1.4066 + 15.0 -120.0 0.51132 + 30.0 -120.0 -0.07964 + 45.0 -120.0 -0.49787 + 60.0 -120.0 -0.64487 + 75.0 -120.0 -0.35755 + 90.0 -120.0 0.18803 + 105.0 -120.0 0.5455 + 120.0 -120.0 0.97289 + 135.0 -120.0 1.16949 + 150.0 -120.0 1.1591 + 165.0 -120.0 1.05012 + 180.0 -120.0 0.76282 + -180.0 -105.0 1.42827 + -165.0 -105.0 1.50406 + -150.0 -105.0 1.72284 + -135.0 -105.0 1.64917 + -120.0 -105.0 1.03764 + -105.0 -105.0 0.56475 + -90.0 -105.0 0.20084 + -75.0 -105.0 0.20821 + -60.0 -105.0 1.22814 + -45.0 -105.0 2.98189 + -30.0 -105.0 3.57647 + -15.0 -105.0 2.65211 + 0.0 -105.0 1.95317 + 15.0 -105.0 1.65224 + 30.0 -105.0 1.43567 + 45.0 -105.0 0.92486 + 60.0 -105.0 0.55065 + 75.0 -105.0 0.46027 + 90.0 -105.0 0.6047 + 105.0 -105.0 1.02077 + 120.0 -105.0 1.33189 + 135.0 -105.0 1.51499 + 150.0 -105.0 1.50886 + 165.0 -105.0 1.53133 + 180.0 -105.0 1.42827 + -180.0 -90.0 1.90401 + -165.0 -90.0 2.03939 + -150.0 -90.0 2.29924 + -135.0 -90.0 1.79055 + -120.0 -90.0 1.3528 + -105.0 -90.0 1.02391 + -90.0 -90.0 0.90562 + -75.0 -90.0 1.23397 + -60.0 -90.0 2.45075 + -45.0 -90.0 3.45522 + -30.0 -90.0 3.09983 + -15.0 -90.0 2.62493 + 0.0 -90.0 2.65047 + 15.0 -90.0 3.09474 + 30.0 -90.0 2.79428 + 45.0 -90.0 2.15793 + 60.0 -90.0 1.57482 + 75.0 -90.0 1.3331 + 90.0 -90.0 1.13012 + 105.0 -90.0 1.17449 + 120.0 -90.0 1.41199 + 135.0 -90.0 1.62671 + 150.0 -90.0 1.81755 + 165.0 -90.0 1.82118 + 180.0 -90.0 1.90401 + -180.0 -75.0 1.80621 + -165.0 -75.0 2.0808 + -150.0 -75.0 2.03556 + -135.0 -75.0 1.68691 + -120.0 -75.0 1.29208 + -105.0 -75.0 1.22509 + -90.0 -75.0 1.43311 + -75.0 -75.0 2.16375 + -60.0 -75.0 2.1732 + -45.0 -75.0 2.21268 + -30.0 -75.0 2.13049 + -15.0 -75.0 2.40205 + 0.0 -75.0 3.24329 + 15.0 -75.0 4.06613 + 30.0 -75.0 3.57523 + 45.0 -75.0 2.86443 + 60.0 -75.0 2.31976 + 75.0 -75.0 1.66472 + 90.0 -75.0 1.27852 + 105.0 -75.0 1.09103 + 120.0 -75.0 1.36656 + 135.0 -75.0 1.53314 + 150.0 -75.0 1.59747 + 165.0 -75.0 1.64225 + 180.0 -75.0 1.80621 + -180.0 -60.0 0.94133 + -165.0 -60.0 1.07716 + -150.0 -60.0 1.06365 + -135.0 -60.0 0.96211 + -120.0 -60.0 0.94411 + -105.0 -60.0 1.25994 + -90.0 -60.0 0.79628 + -75.0 -60.0 0.57562 + -60.0 -60.0 0.56577 + -45.0 -60.0 0.74572 + -30.0 -60.0 1.24745 + -15.0 -60.0 2.21612 + 0.0 -60.0 3.54214 + 15.0 -60.0 3.78367 + 30.0 -60.0 3.4012 + 45.0 -60.0 2.89718 + 60.0 -60.0 1.94715 + 75.0 -60.0 1.36042 + 90.0 -60.0 0.7925 + 105.0 -60.0 0.57769 + 120.0 -60.0 0.77935 + 135.0 -60.0 0.79351 + 150.0 -60.0 0.75367 + 165.0 -60.0 0.78581 + 180.0 -60.0 0.94133 + -180.0 -45.0 -0.67275 + -165.0 -45.0 -0.59212 + -150.0 -45.0 -0.422 + -135.0 -45.0 -0.01106 + -120.0 -45.0 -0.5147 + -105.0 -45.0 -0.80922 + -90.0 -45.0 -0.99538 + -75.0 -45.0 -1.0643 + -60.0 -45.0 -0.87844 + -45.0 -45.0 -0.24576 + -30.0 -45.0 0.77634 + -15.0 -45.0 2.05251 + 0.0 -45.0 2.78505 + 15.0 -45.0 3.13379 + 30.0 -45.0 2.85045 + 45.0 -45.0 2.19151 + 60.0 -45.0 1.16243 + 75.0 -45.0 0.2072 + 90.0 -45.0 -0.42237 + 105.0 -45.0 -0.4646 + 120.0 -45.0 -0.38665 + 135.0 -45.0 -0.55232 + 150.0 -45.0 -0.67078 + 165.0 -45.0 -0.6783 + 180.0 -45.0 -0.67275 + -180.0 -30.0 -2.46944 + -165.0 -30.0 -2.32595 + -150.0 -30.0 -1.71439 + -135.0 -30.0 -2.48703 + -120.0 -30.0 -2.56054 + -105.0 -30.0 -2.46215 + -90.0 -30.0 -2.37111 + -75.0 -30.0 -2.19037 + -60.0 -30.0 -1.62432 + -45.0 -30.0 -0.7237 + -30.0 -30.0 0.35895 + -15.0 -30.0 1.35947 + 0.0 -30.0 2.12358 + 15.0 -30.0 2.36496 + 30.0 -30.0 1.96636 + 45.0 -30.0 1.05275 + 60.0 -30.0 -0.26183 + 75.0 -30.0 -1.16368 + 90.0 -30.0 -1.65442 + 105.0 -30.0 -1.64196 + 120.0 -30.0 -1.86484 + 135.0 -30.0 -2.09366 + 150.0 -30.0 -2.28268 + 165.0 -30.0 -2.41932 + 180.0 -30.0 -2.46944 + -180.0 -15.0 -3.82546 + -165.0 -15.0 -3.22967 + -150.0 -15.0 -3.93518 + -135.0 -15.0 -3.85949 + -120.0 -15.0 -3.58321 + -105.0 -15.0 -3.28549 + -90.0 -15.0 -3.01617 + -75.0 -15.0 -2.60005 + -60.0 -15.0 -1.92147 + -45.0 -15.0 -1.14234 + -30.0 -15.0 -0.00873 + -15.0 -15.0 1.14445 + 0.0 -15.0 1.77335 + 15.0 -15.0 1.79047 + 30.0 -15.0 1.09507 + 45.0 -15.0 -0.16297 + 60.0 -15.0 -1.43516 + 75.0 -15.0 -2.26699 + 90.0 -15.0 -2.45933 + 105.0 -15.0 -2.70542 + 120.0 -15.0 -3.03929 + 135.0 -15.0 -3.35545 + 150.0 -15.0 -3.62364 + 165.0 -15.0 -3.79758 + 180.0 -15.0 -3.82546 + -180.0 0.0 -3.8299 + -165.0 0.0 -4.37645 + -150.0 0.0 -4.29456 + -135.0 0.0 -4.01846 + -120.0 0.0 -3.66843 + -105.0 0.0 -3.3124 + -90.0 0.0 -2.96646 + -75.0 0.0 -2.58028 + -60.0 0.0 -2.08554 + -45.0 0.0 -0.9905 + -30.0 0.0 0.42261 + -15.0 0.0 1.35374 + 0.0 0.0 1.69885 + 15.0 0.0 1.35374 + 30.0 0.0 0.42261 + 45.0 0.0 -1.0031 + 60.0 0.0 -2.08554 + 75.0 0.0 -2.58028 + 90.0 0.0 -2.96646 + 105.0 0.0 -3.3124 + 120.0 0.0 -3.66843 + 135.0 0.0 -4.01846 + 150.0 0.0 -4.29456 + 165.0 0.0 -4.37645 + 180.0 0.0 -3.8299 + -180.0 15.0 -3.82546 + -165.0 15.0 -3.79758 + -150.0 15.0 -3.62364 + -135.0 15.0 -3.35545 + -120.0 15.0 -3.03929 + -105.0 15.0 -2.70542 + -90.0 15.0 -2.45933 + -75.0 15.0 -2.26699 + -60.0 15.0 -1.43516 + -45.0 15.0 -0.16297 + -30.0 15.0 1.09507 + -15.0 15.0 1.79047 + 0.0 15.0 1.77335 + 15.0 15.0 1.14445 + 30.0 15.0 -0.00873 + 45.0 15.0 -1.14234 + 60.0 15.0 -1.92147 + 75.0 15.0 -2.60005 + 90.0 15.0 -3.01617 + 105.0 15.0 -3.28549 + 120.0 15.0 -3.58321 + 135.0 15.0 -3.85949 + 150.0 15.0 -3.93518 + 165.0 15.0 -3.23037 + 180.0 15.0 -3.82546 + -180.0 30.0 -2.46944 + -165.0 30.0 -2.41932 + -150.0 30.0 -2.28268 + -135.0 30.0 -2.09366 + -120.0 30.0 -1.86484 + -105.0 30.0 -1.64196 + -90.0 30.0 -1.65442 + -75.0 30.0 -1.16368 + -60.0 30.0 -0.26183 + -45.0 30.0 1.05275 + -30.0 30.0 1.96636 + -15.0 30.0 2.36496 + 0.0 30.0 2.12358 + 15.0 30.0 1.35947 + 30.0 30.0 0.35055 + 45.0 30.0 -0.7237 + 60.0 30.0 -1.62432 + 75.0 30.0 -2.19037 + 90.0 30.0 -2.37111 + 105.0 30.0 -2.46215 + 120.0 30.0 -2.56054 + 135.0 30.0 -2.48703 + 150.0 30.0 -1.70729 + 165.0 30.0 -2.32595 + 180.0 30.0 -2.46944 + -180.0 45.0 -0.67275 + -165.0 45.0 -0.6783 + -150.0 45.0 -0.67078 + -135.0 45.0 -0.55232 + -120.0 45.0 -0.38665 + -105.0 45.0 -0.4646 + -90.0 45.0 -0.42237 + -75.0 45.0 0.2072 + -60.0 45.0 1.16243 + -45.0 45.0 2.19151 + -30.0 45.0 2.85045 + -15.0 45.0 3.13379 + 0.0 45.0 2.78505 + 15.0 45.0 2.06071 + 30.0 45.0 0.77634 + 45.0 45.0 -0.24576 + 60.0 45.0 -0.87844 + 75.0 45.0 -1.0643 + 90.0 45.0 -0.99538 + 105.0 45.0 -0.80922 + 120.0 45.0 -0.5147 + 135.0 45.0 -0.01106 + 150.0 45.0 -0.422 + 165.0 45.0 -0.59212 + 180.0 45.0 -0.67275 + -180.0 60.0 0.94133 + -165.0 60.0 0.78581 + -150.0 60.0 0.75367 + -135.0 60.0 0.79351 + -120.0 60.0 0.77935 + -105.0 60.0 0.57769 + -90.0 60.0 0.7925 + -75.0 60.0 1.36042 + -60.0 60.0 1.94715 + -45.0 60.0 2.89718 + -30.0 60.0 3.4012 + -15.0 60.0 3.78367 + 0.0 60.0 3.54214 + 15.0 60.0 2.19742 + 30.0 60.0 1.24745 + 45.0 60.0 0.74572 + 60.0 60.0 0.56577 + 75.0 60.0 0.57562 + 90.0 60.0 0.79628 + 105.0 60.0 1.25994 + 120.0 60.0 0.94411 + 135.0 60.0 0.96211 + 150.0 60.0 1.06365 + 165.0 60.0 1.07716 + 180.0 60.0 0.94133 + -180.0 75.0 1.80621 + -165.0 75.0 1.64225 + -150.0 75.0 1.59747 + -135.0 75.0 1.53314 + -120.0 75.0 1.36656 + -105.0 75.0 1.09103 + -90.0 75.0 1.27852 + -75.0 75.0 1.66472 + -60.0 75.0 2.31976 + -45.0 75.0 2.86443 + -30.0 75.0 3.57523 + -15.0 75.0 4.06613 + 0.0 75.0 3.24329 + 15.0 75.0 2.40295 + 30.0 75.0 2.13049 + 45.0 75.0 2.21268 + 60.0 75.0 2.1732 + 75.0 75.0 2.16375 + 90.0 75.0 1.43311 + 105.0 75.0 1.22509 + 120.0 75.0 1.29208 + 135.0 75.0 1.68691 + 150.0 75.0 2.03556 + 165.0 75.0 2.0808 + 180.0 75.0 1.80621 + -180.0 90.0 1.90401 + -165.0 90.0 1.82118 + -150.0 90.0 1.81755 + -135.0 90.0 1.62671 + -120.0 90.0 1.41199 + -105.0 90.0 1.17449 + -90.0 90.0 1.13012 + -75.0 90.0 1.3331 + -60.0 90.0 1.57482 + -45.0 90.0 2.15793 + -30.0 90.0 2.79428 + -15.0 90.0 3.09474 + 0.0 90.0 2.65047 + 15.0 90.0 2.62493 + 30.0 90.0 3.09673 + 45.0 90.0 3.45522 + 60.0 90.0 2.45075 + 75.0 90.0 1.23397 + 90.0 90.0 0.90562 + 105.0 90.0 1.02391 + 120.0 90.0 1.3528 + 135.0 90.0 1.79055 + 150.0 90.0 2.29924 + 165.0 90.0 2.03939 + 180.0 90.0 1.90401 + -180.0 105.0 1.42827 + -165.0 105.0 1.53133 + -150.0 105.0 1.50886 + -135.0 105.0 1.51499 + -120.0 105.0 1.33189 + -105.0 105.0 1.02077 + -90.0 105.0 0.6047 + -75.0 105.0 0.46027 + -60.0 105.0 0.55065 + -45.0 105.0 0.92486 + -30.0 105.0 1.43567 + -15.0 105.0 1.65224 + 0.0 105.0 1.95317 + 15.0 105.0 2.65211 + 30.0 105.0 3.58847 + 45.0 105.0 2.98189 + 60.0 105.0 1.22814 + 75.0 105.0 0.20821 + 90.0 105.0 0.20084 + 105.0 105.0 0.56475 + 120.0 105.0 1.03764 + 135.0 105.0 1.64917 + 150.0 105.0 1.72204 + 165.0 105.0 1.50406 + 180.0 105.0 1.42827 + -180.0 120.0 0.76282 + -165.0 120.0 1.05012 + -150.0 120.0 1.1591 + -135.0 120.0 1.16949 + -120.0 120.0 0.97289 + -105.0 120.0 0.5455 + -90.0 120.0 0.18803 + -75.0 120.0 -0.35755 + -60.0 120.0 -0.64487 + -45.0 120.0 -0.49787 + -30.0 120.0 -0.07964 + -15.0 120.0 0.51132 + 0.0 120.0 1.4066 + 15.0 120.0 2.47433 + 30.0 120.0 3.49117 + 45.0 120.0 1.42775 + 60.0 120.0 -0.44624 + 75.0 120.0 -0.87022 + 90.0 120.0 -0.55868 + 105.0 120.0 -0.17578 + 120.0 120.0 0.46767 + 135.0 120.0 0.80302 + 150.0 120.0 0.73536 + 165.0 120.0 0.65049 + 180.0 120.0 0.76282 + -180.0 135.0 0.22137 + -165.0 135.0 0.599 + -150.0 135.0 0.82176 + -135.0 135.0 0.78961 + -120.0 135.0 0.35059 + -105.0 135.0 -0.14353 + -90.0 135.0 -0.54882 + -75.0 135.0 -1.11846 + -60.0 135.0 -1.54005 + -45.0 135.0 -1.57764 + -30.0 135.0 -1.08446 + -15.0 135.0 -0.13409 + 0.0 135.0 1.01469 + 15.0 135.0 2.08125 + 30.0 135.0 2.15102 + 45.0 135.0 -0.87317 + 60.0 135.0 -1.99291 + 75.0 135.0 -1.97985 + 90.0 135.0 -1.48283 + 105.0 135.0 -0.91494 + 120.0 135.0 -0.45372 + 135.0 135.0 -0.2512 + 150.0 135.0 -0.25069 + 165.0 135.0 -0.11507 + 180.0 135.0 0.22137 + -180.0 150.0 -0.05487 + -165.0 150.0 0.30007 + -150.0 150.0 0.37394 + -135.0 150.0 0.15792 + -120.0 150.0 -0.27502 + -105.0 150.0 -0.79693 + -90.0 150.0 -1.32072 + -75.0 150.0 -1.85418 + -60.0 150.0 -2.27657 + -45.0 150.0 -2.28172 + -30.0 150.0 -1.60792 + -15.0 150.0 -0.47503 + 0.0 150.0 0.68197 + 15.0 150.0 1.60921 + 30.0 150.0 -0.65594 + 45.0 150.0 -2.36553 + 60.0 150.0 -2.95919 + 75.0 150.0 -2.73078 + 90.0 150.0 -2.17397 + 105.0 150.0 -1.65041 + 120.0 150.0 -1.25474 + 135.0 150.0 -1.02443 + 150.0 150.0 -0.83418 + 165.0 150.0 -0.49639 + 180.0 150.0 -0.05487 + -180.0 165.0 -0.03043 + -165.0 165.0 0.10146 + -150.0 165.0 -0.04055 + -135.0 165.0 -0.44166 + -120.0 165.0 -0.94989 + -105.0 165.0 -1.47132 + -90.0 165.0 -1.96898 + -75.0 165.0 -2.4591 + -60.0 165.0 -2.82977 + -45.0 165.0 -2.72832 + -30.0 165.0 -1.85441 + -15.0 165.0 -0.59328 + 0.0 165.0 0.47583 + 15.0 165.0 0.28654 + 30.0 165.0 -1.66034 + 45.0 165.0 -2.85897 + 60.0 165.0 -3.27921 + 75.0 165.0 -2.96238 + 90.0 165.0 -2.44752 + 105.0 165.0 -1.99117 + 120.0 165.0 -1.60564 + 135.0 165.0 -1.22723 + 150.0 165.0 -0.84288 + 165.0 165.0 -0.40282 + 180.0 165.0 -0.03043 + -180.0 180.0 0.0 + -165.0 180.0 -0.15918 + -150.0 180.0 -0.46924 + -135.0 180.0 -0.94887 + -120.0 180.0 -1.41919 + -105.0 180.0 -1.89608 + -90.0 180.0 -2.35024 + -75.0 180.0 -2.81648 + -60.0 180.0 -3.17758 + -45.0 180.0 -2.91092 + -30.0 180.0 -1.84916 + -15.0 180.0 -0.61868 + 0.0 180.0 1.44957 + 15.0 180.0 -0.61868 + 30.0 180.0 -1.84916 + 45.0 180.0 -2.91092 + 60.0 180.0 -3.17758 + 75.0 180.0 -2.81793 + 90.0 180.0 -2.34954 + 105.0 180.0 -1.91578 + 120.0 180.0 -1.41919 + 135.0 180.0 -0.94887 + 150.0 180.0 -0.46924 + 165.0 180.0 -0.15918 + 180.0 180.0 0.0 + +3 25 25 + -180.0 -180.0 0.98936 + -165.0 -180.0 0.76408 + -150.0 -180.0 0.21674 + -135.0 -180.0 -0.182 + -120.0 -180.0 -0.37729 + -105.0 -180.0 -0.47834 + -90.0 -180.0 -0.59267 + -75.0 -180.0 -0.93985 + -60.0 -180.0 -1.55558 + -45.0 -180.0 -2.01849 + -30.0 -180.0 -1.94076 + -15.0 -180.0 -1.464 + 0.0 -180.0 0.18253 + 15.0 -180.0 -0.80364 + 30.0 -180.0 -1.32974 + 45.0 -180.0 -1.31658 + 60.0 -180.0 -0.5014 + 75.0 -180.0 0.20431 + 90.0 -180.0 0.39356 + 105.0 -180.0 0.20356 + 120.0 -180.0 -0.16993 + 135.0 -180.0 -0.22733 + 150.0 -180.0 0.13703 + 165.0 -180.0 0.66356 + 180.0 -180.0 0.98936 + -180.0 -165.0 0.96101 + -165.0 -165.0 0.37535 + -150.0 -165.0 -0.35733 + -135.0 -165.0 -0.69994 + -120.0 -165.0 -0.67298 + -105.0 -165.0 -0.58294 + -90.0 -165.0 -0.66465 + -75.0 -165.0 -1.02945 + -60.0 -165.0 -1.72427 + -45.0 -165.0 -2.19357 + -30.0 -165.0 -2.26378 + -15.0 -165.0 -1.7385 + 0.0 -165.0 -0.80969 + 15.0 -165.0 -1.16164 + 30.0 -165.0 -1.62772 + 45.0 -165.0 -1.51932 + 60.0 -165.0 -0.62569 + 75.0 -165.0 0.1313 + 90.0 -165.0 0.41019 + 105.0 -165.0 0.32974 + 120.0 -165.0 0.19191 + 135.0 -165.0 0.3232 + 150.0 -165.0 0.68257 + 165.0 -165.0 1.03015 + 180.0 -165.0 0.96101 + -180.0 -150.0 0.72651 + -165.0 -150.0 -0.04361 + -150.0 -150.0 -0.78147 + -135.0 -150.0 -0.90703 + -120.0 -150.0 -0.65095 + -105.0 -150.0 -0.48165 + -90.0 -150.0 -0.59657 + -75.0 -150.0 -1.14449 + -60.0 -150.0 -1.75396 + -45.0 -150.0 -2.279 + -30.0 -150.0 -2.14873 + -15.0 -150.0 -0.26757 + 0.0 -150.0 -0.77578 + 15.0 -150.0 -1.30595 + 30.0 -150.0 -1.79607 + 45.0 -150.0 -1.55982 + 60.0 -150.0 -0.57905 + 75.0 -150.0 0.30576 + 90.0 -150.0 0.70711 + 105.0 -150.0 0.68903 + 120.0 -150.0 0.53594 + 135.0 -150.0 0.60304 + 150.0 -150.0 0.88805 + 165.0 -150.0 0.9972 + 180.0 -150.0 0.72651 + -180.0 -135.0 0.155 + -165.0 -135.0 -0.20013 + -150.0 -135.0 -0.7966 + -135.0 -135.0 -0.74958 + -120.0 -135.0 -0.43624 + -105.0 -135.0 -0.36715 + -90.0 -135.0 -0.58938 + -75.0 -135.0 -0.99698 + -60.0 -135.0 -1.59208 + -45.0 -135.0 -1.67026 + -30.0 -135.0 0.50672 + -15.0 -135.0 -0.03293 + 0.0 -135.0 -0.84501 + 15.0 -135.0 -1.52731 + 30.0 -135.0 -1.89898 + 45.0 -135.0 -1.54469 + 60.0 -135.0 -0.53752 + 75.0 -135.0 0.40003 + 90.0 -135.0 0.88952 + 105.0 -135.0 0.8215 + 120.0 -135.0 0.58663 + 135.0 -135.0 0.56781 + 150.0 -135.0 0.74002 + 165.0 -135.0 0.84486 + 180.0 -135.0 0.155 + -180.0 -120.0 0.34021 + -165.0 -120.0 -0.20306 + -150.0 -120.0 -0.62787 + -135.0 -120.0 -0.55418 + -120.0 -120.0 -0.38986 + -105.0 -120.0 -0.44533 + -90.0 -120.0 -0.60179 + -75.0 -120.0 -0.93351 + -60.0 -120.0 -1.09198 + -45.0 -120.0 -0.18408 + -30.0 -120.0 1.24545 + -15.0 -120.0 -0.24279 + 0.0 -120.0 -1.24581 + 15.0 -120.0 -1.76363 + 30.0 -120.0 -1.8081 + 45.0 -120.0 -1.40319 + 60.0 -120.0 -0.63233 + 75.0 -120.0 0.15411 + 90.0 -120.0 0.5864 + 105.0 -120.0 0.51937 + 120.0 -120.0 0.25822 + 135.0 -120.0 0.13668 + 150.0 -120.0 0.23659 + 165.0 -120.0 0.46899 + 180.0 -120.0 0.34021 + -180.0 -105.0 -0.15437 + -165.0 -105.0 -0.1406 + -150.0 -105.0 -0.54321 + -135.0 -105.0 -0.58112 + -120.0 -105.0 -0.64967 + -105.0 -105.0 -0.71916 + -90.0 -105.0 -0.78801 + -75.0 -105.0 -0.76163 + -60.0 -105.0 -0.33401 + -45.0 -105.0 0.9172 + -30.0 -105.0 0.65423 + -15.0 -105.0 -0.84456 + 0.0 -105.0 -1.63476 + 15.0 -105.0 -1.65992 + 30.0 -105.0 -1.33178 + 45.0 -105.0 -1.08999 + 60.0 -105.0 -0.74243 + 75.0 -105.0 -0.33157 + 90.0 -105.0 -0.20618 + 105.0 -105.0 -0.07103 + 120.0 -105.0 -0.25941 + 135.0 -105.0 -0.37634 + 150.0 -105.0 -0.12892 + 165.0 -105.0 0.19386 + 180.0 -105.0 -0.15437 + -180.0 -90.0 0.4463 + -165.0 -90.0 0.02406 + -150.0 -90.0 -0.42821 + -135.0 -90.0 -0.76736 + -120.0 -90.0 -0.93537 + -105.0 -90.0 -0.86621 + -90.0 -90.0 -0.66178 + -75.0 -90.0 -0.23513 + -60.0 -90.0 0.41508 + -45.0 -90.0 0.97897 + -30.0 -90.0 -0.30358 + -15.0 -90.0 -1.42025 + 0.0 -90.0 -1.62146 + 15.0 -90.0 -0.98816 + 30.0 -90.0 -0.58148 + 45.0 -90.0 -0.49791 + 60.0 -90.0 -0.32045 + 75.0 -90.0 -0.39639 + 90.0 -90.0 -0.94422 + 105.0 -90.0 -0.74539 + 120.0 -90.0 -0.60241 + 135.0 -90.0 -0.56295 + 150.0 -90.0 -0.15877 + 165.0 -90.0 0.33609 + 180.0 -90.0 0.4463 + -180.0 -75.0 0.69562 + -165.0 -75.0 0.16403 + -150.0 -75.0 -0.43627 + -135.0 -75.0 -0.79169 + -120.0 -75.0 -0.80743 + -105.0 -75.0 -0.48767 + -90.0 -75.0 0.12397 + -75.0 -75.0 0.80972 + -60.0 -75.0 0.52616 + -45.0 -75.0 -0.13884 + -30.0 -75.0 -1.08459 + -15.0 -75.0 -1.556 + 0.0 -75.0 -1.12531 + 15.0 -75.0 -0.19831 + 30.0 -75.0 -0.00344 + 45.0 -75.0 0.01061 + 60.0 -75.0 0.11066 + 75.0 -75.0 -0.12406 + 90.0 -75.0 -0.8198 + 105.0 -75.0 -1.04369 + 120.0 -75.0 -0.62525 + 135.0 -75.0 -0.37223 + 150.0 -75.0 0.09012 + 165.0 -75.0 0.58855 + 180.0 -75.0 0.69562 + -180.0 -60.0 0.70531 + -165.0 -60.0 0.15456 + -150.0 -60.0 -0.40882 + -135.0 -60.0 -0.57653 + -120.0 -60.0 -0.20146 + -105.0 -60.0 0.21285 + -90.0 -60.0 0.15007 + -75.0 -60.0 0.06572 + -60.0 -60.0 -0.22861 + -45.0 -60.0 -0.75313 + -30.0 -60.0 -1.17725 + -15.0 -60.0 -1.0704 + 0.0 -60.0 -0.29306 + 15.0 -60.0 0.11777 + 30.0 -60.0 0.42905 + 45.0 -60.0 0.53679 + 60.0 -60.0 0.52038 + 75.0 -60.0 0.27617 + 90.0 -60.0 -0.36078 + 105.0 -60.0 -0.66569 + 120.0 -60.0 -0.35068 + 135.0 -60.0 -0.13164 + 150.0 -60.0 0.27666 + 165.0 -60.0 0.70865 + 180.0 -60.0 0.70531 + -180.0 -45.0 0.42237 + -165.0 -45.0 -0.14148 + -150.0 -45.0 -0.50856 + -135.0 -45.0 -0.14423 + -120.0 -45.0 -0.53339 + -105.0 -45.0 -0.514 + -90.0 -45.0 -0.3329 + -75.0 -45.0 -0.24488 + -60.0 -45.0 -0.32054 + -45.0 -45.0 -0.40379 + -30.0 -45.0 -0.41006 + -15.0 -45.0 -0.23372 + 0.0 -45.0 0.07185 + 15.0 -45.0 0.70729 + 30.0 -45.0 1.16881 + 45.0 -45.0 1.23276 + 60.0 -45.0 0.77518 + 75.0 -45.0 0.5197 + 90.0 -45.0 -0.12956 + 105.0 -45.0 -0.24028 + 120.0 -45.0 -0.08791 + 135.0 -45.0 0.02315 + 150.0 -45.0 0.32774 + 165.0 -45.0 0.5533 + 180.0 -45.0 0.42237 + -180.0 -30.0 0.127 + -165.0 -30.0 -0.36697 + -150.0 -30.0 -0.33178 + -135.0 -30.0 -1.09856 + -120.0 -30.0 -1.01098 + -105.0 -30.0 -0.6178 + -90.0 -30.0 -0.18232 + -75.0 -30.0 0.14143 + -60.0 -30.0 0.40819 + -45.0 -30.0 0.50556 + -30.0 -30.0 0.34379 + -15.0 -30.0 0.31224 + 0.0 -30.0 0.97008 + 15.0 -30.0 1.70616 + 30.0 -30.0 1.99942 + 45.0 -30.0 1.79196 + 60.0 -30.0 1.26978 + 75.0 -30.0 0.65732 + 90.0 -30.0 0.04223 + 105.0 -30.0 0.22658 + 120.0 -30.0 0.08209 + 135.0 -30.0 0.05525 + 150.0 -30.0 0.22382 + 165.0 -30.0 0.33964 + 180.0 -30.0 0.127 + -180.0 -15.0 -0.06517 + -165.0 -15.0 -0.13598 + -150.0 -15.0 -1.30614 + -135.0 -15.0 -1.09555 + -120.0 -15.0 -0.64991 + -105.0 -15.0 -0.06482 + -90.0 -15.0 0.49509 + -75.0 -15.0 0.92103 + -60.0 -15.0 1.94755 + -45.0 -15.0 0.95164 + -30.0 -15.0 0.8787 + -15.0 -15.0 1.42479 + 0.0 -15.0 2.06338 + 15.0 -15.0 2.50243 + 30.0 -15.0 2.59266 + 45.0 -15.0 2.02131 + 60.0 -15.0 1.26236 + 75.0 -15.0 0.65759 + 90.0 -15.0 0.60601 + 105.0 -15.0 0.40777 + 120.0 -15.0 0.08605 + 135.0 -15.0 -0.02333 + 150.0 -15.0 0.06947 + 165.0 -15.0 0.13044 + 180.0 -15.0 -0.06517 + -180.0 0.0 -1.44412 + -165.0 0.0 -1.37206 + -150.0 0.0 -0.97055 + -135.0 0.0 -0.54692 + -120.0 0.0 -0.04768 + -105.0 0.0 0.65462 + -90.0 0.0 1.09803 + -75.0 0.0 1.4118 + -60.0 0.0 1.23685 + -45.0 0.0 1.32368 + -30.0 0.0 1.83555 + -15.0 0.0 2.29146 + 0.0 0.0 2.61632 + 15.0 0.0 2.73204 + 30.0 0.0 2.49607 + 45.0 0.0 1.76205 + 60.0 0.0 1.23208 + 75.0 0.0 1.11843 + 90.0 0.0 1.50389 + 105.0 0.0 0.20088 + 120.0 0.0 -0.22667 + 135.0 0.0 -0.38306 + 150.0 0.0 -0.27813 + 165.0 0.0 -0.08165 + 180.0 0.0 -1.44412 + -180.0 15.0 -1.54337 + -165.0 15.0 -0.94875 + -150.0 15.0 -0.4463 + -135.0 15.0 -0.06444 + -120.0 15.0 0.39675 + -105.0 15.0 0.90513 + -90.0 15.0 1.24019 + -75.0 15.0 1.18954 + -60.0 15.0 1.36753 + -45.0 15.0 1.8229 + -30.0 15.0 2.22229 + -15.0 15.0 2.44694 + 0.0 15.0 2.44244 + 15.0 15.0 2.26164 + 30.0 15.0 1.85516 + 45.0 15.0 1.56722 + 60.0 15.0 1.43193 + 75.0 15.0 0.71918 + 90.0 15.0 0.14053 + 105.0 15.0 -0.36429 + 120.0 15.0 -0.76466 + 135.0 15.0 -0.87217 + 150.0 15.0 -0.57197 + 165.0 15.0 -1.61569 + 180.0 15.0 -1.54337 + -180.0 30.0 -1.09485 + -165.0 30.0 -0.56681 + -150.0 30.0 -0.13387 + -135.0 30.0 0.19412 + -120.0 30.0 0.57374 + -105.0 30.0 0.86366 + -90.0 30.0 0.80314 + -75.0 30.0 1.08125 + -60.0 30.0 1.39143 + -45.0 30.0 1.86048 + -30.0 30.0 2.01491 + -15.0 30.0 2.03904 + 0.0 30.0 1.77856 + 15.0 30.0 1.48754 + 30.0 30.0 1.53762 + 45.0 30.0 1.22766 + 60.0 30.0 0.55347 + 75.0 30.0 -0.06469 + 90.0 30.0 -0.47099 + 105.0 30.0 -0.82958 + 120.0 30.0 -1.01883 + 135.0 30.0 -0.75479 + 150.0 30.0 -1.39221 + 165.0 30.0 -1.55942 + 180.0 30.0 -1.09485 + -180.0 45.0 -0.55882 + -165.0 45.0 -0.22825 + -150.0 45.0 0.01795 + -135.0 45.0 0.21896 + -120.0 45.0 0.49238 + -105.0 45.0 0.39403 + -90.0 45.0 0.4887 + -75.0 45.0 0.90318 + -60.0 45.0 1.0673 + -45.0 45.0 1.40576 + -30.0 45.0 1.504 + -15.0 45.0 1.39328 + 0.0 45.0 1.13519 + 15.0 45.0 1.11176 + 30.0 45.0 0.55506 + 45.0 45.0 0.04408 + 60.0 45.0 -0.2593 + 75.0 45.0 -0.42888 + 90.0 45.0 -0.51963 + 105.0 45.0 -0.55634 + 120.0 45.0 -0.25212 + 135.0 45.0 -0.62098 + 150.0 45.0 -1.22694 + 165.0 45.0 -1.05054 + 180.0 45.0 -0.55882 + -180.0 60.0 -0.18285 + -165.0 60.0 -0.0865 + -150.0 60.0 0.00476 + -135.0 60.0 0.11545 + -120.0 60.0 0.16266 + -105.0 60.0 0.01161 + -90.0 60.0 0.39632 + -75.0 60.0 0.75519 + -60.0 60.0 0.96557 + -45.0 60.0 0.9764 + -30.0 60.0 0.97745 + -15.0 60.0 0.97978 + 0.0 60.0 0.79555 + 15.0 60.0 -0.15675 + 30.0 60.0 -0.51647 + 45.0 60.0 -0.39418 + 60.0 60.0 -0.15303 + 75.0 60.0 -0.008 + 90.0 60.0 0.09982 + 105.0 60.0 0.37002 + 120.0 60.0 0.12378 + 135.0 60.0 -0.63827 + 150.0 60.0 -0.59589 + 165.0 60.0 -0.38041 + 180.0 60.0 -0.18285 + -180.0 75.0 -0.066 + -165.0 75.0 -0.07528 + -150.0 75.0 -0.04119 + -135.0 75.0 -0.07933 + -120.0 75.0 -0.19424 + -105.0 75.0 -0.27213 + -90.0 75.0 0.0 + -75.0 75.0 0.40627 + -60.0 75.0 0.67141 + -45.0 75.0 0.48954 + -30.0 75.0 0.49392 + -15.0 75.0 0.53926 + 0.0 75.0 -0.43613 + 15.0 75.0 -0.91296 + 30.0 75.0 -0.57046 + 45.0 75.0 0.20602 + 60.0 75.0 0.66426 + 75.0 75.0 0.78486 + 90.0 75.0 0.83638 + 105.0 75.0 0.47569 + 120.0 75.0 -0.24156 + 135.0 75.0 -0.36935 + 150.0 75.0 -0.03276 + 165.0 75.0 -0.00079 + 180.0 75.0 -0.066 + -180.0 90.0 -0.19813 + -165.0 90.0 -0.18275 + -150.0 90.0 -0.13564 + -135.0 90.0 -0.16443 + -120.0 90.0 -0.25121 + -105.0 90.0 -0.36588 + -90.0 90.0 -0.30532 + -75.0 90.0 -0.05335 + -60.0 90.0 -0.11065 + -45.0 90.0 -0.24703 + -30.0 90.0 -0.35383 + -15.0 90.0 -0.66704 + 0.0 90.0 -1.22785 + 15.0 90.0 -0.99837 + 30.0 90.0 0.07165 + 45.0 90.0 1.1709 + 60.0 90.0 1.52568 + 75.0 90.0 1.19212 + 90.0 90.0 0.65821 + 105.0 90.0 0.07691 + 120.0 90.0 -0.25244 + 135.0 90.0 -0.10611 + 150.0 90.0 0.09358 + 165.0 90.0 0.00731 + 180.0 90.0 -0.19813 + -180.0 105.0 -0.3485 + -165.0 105.0 -0.15035 + -150.0 105.0 -0.40367 + -135.0 105.0 -0.01197 + -120.0 105.0 -0.061 + -105.0 105.0 -0.1519 + -90.0 105.0 -0.31715 + -75.0 105.0 -0.62391 + -60.0 105.0 -0.90231 + -45.0 105.0 -1.37607 + -30.0 105.0 -1.62179 + -15.0 105.0 -1.73579 + 0.0 105.0 -1.64875 + 15.0 105.0 -0.75542 + 30.0 105.0 0.71157 + 45.0 105.0 1.26356 + 60.0 105.0 0.7596 + 75.0 105.0 0.594 + 90.0 105.0 0.30667 + 105.0 105.0 -0.06284 + 120.0 105.0 -0.20456 + 135.0 105.0 -0.08836 + 150.0 105.0 -0.1659 + 165.0 105.0 -0.35505 + 180.0 105.0 -0.3485 + -180.0 120.0 -0.34576 + -165.0 120.0 0.02576 + -150.0 120.0 0.27228 + -135.0 120.0 0.28454 + -120.0 120.0 0.18375 + -105.0 120.0 0.01398 + -90.0 120.0 -0.27455 + -75.0 120.0 -0.7758 + -60.0 120.0 -1.42554 + -45.0 120.0 -1.99064 + -30.0 120.0 -2.37393 + -15.0 120.0 -2.20009 + 0.0 120.0 -1.60683 + 15.0 120.0 -0.44372 + 30.0 120.0 1.09513 + 45.0 120.0 0.35522 + 60.0 120.0 -0.04151 + 75.0 120.0 0.17766 + 90.0 120.0 0.14305 + 105.0 120.0 -0.13472 + 120.0 120.0 -0.31725 + 135.0 120.0 -0.458 + 150.0 120.0 -0.64821 + 165.0 120.0 -0.63355 + 180.0 120.0 -0.34576 + -180.0 135.0 -0.08457 + -165.0 135.0 0.36013 + -150.0 135.0 0.54446 + -135.0 135.0 0.48098 + -120.0 135.0 0.27776 + -105.0 135.0 0.02335 + -90.0 135.0 -0.28766 + -75.0 135.0 -0.80414 + -60.0 135.0 -1.5133 + -45.0 135.0 -2.20028 + -30.0 135.0 -2.36835 + -15.0 135.0 -2.12483 + 0.0 135.0 -1.376 + 15.0 135.0 -0.25291 + 30.0 135.0 0.78641 + 45.0 135.0 -0.96321 + 60.0 135.0 -0.57499 + 75.0 135.0 -0.00398 + 90.0 135.0 0.08668 + 105.0 135.0 -0.17475 + 120.0 135.0 -0.55212 + 135.0 135.0 -0.94225 + 150.0 135.0 -1.01661 + 165.0 135.0 -0.69656 + 180.0 135.0 -0.08457 + -180.0 150.0 0.2851 + -165.0 150.0 0.66185 + -150.0 150.0 0.69665 + -135.0 150.0 0.48378 + -120.0 150.0 0.16399 + -105.0 150.0 -0.09637 + -90.0 150.0 -0.36878 + -75.0 150.0 -0.80945 + -60.0 150.0 -1.41793 + -45.0 150.0 -2.18914 + -30.0 150.0 -2.20786 + -15.0 150.0 -1.82363 + 0.0 150.0 -1.11629 + 15.0 150.0 -0.04735 + 30.0 150.0 -1.17126 + 45.0 150.0 -1.34899 + 60.0 150.0 -0.62467 + 75.0 150.0 0.05642 + 90.0 150.0 0.17332 + 105.0 150.0 -0.14673 + 120.0 150.0 -0.698 + 135.0 150.0 -1.11306 + 150.0 150.0 -1.02621 + 165.0 150.0 -0.41495 + 180.0 150.0 0.2851 + -180.0 165.0 0.76902 + -165.0 165.0 0.89311 + -150.0 165.0 0.59358 + -135.0 165.0 0.25887 + -120.0 165.0 -0.03955 + -105.0 165.0 -0.24006 + -90.0 165.0 -0.46456 + -75.0 165.0 -0.8317 + -60.0 165.0 -1.40143 + -45.0 165.0 -1.95471 + -30.0 165.0 -2.00388 + -15.0 165.0 -1.56184 + 0.0 165.0 -0.83182 + 15.0 165.0 -0.45132 + 30.0 165.0 -1.23096 + 45.0 165.0 -1.2265 + 60.0 165.0 -0.44761 + 75.0 165.0 0.25891 + 90.0 165.0 0.39936 + 105.0 165.0 0.0765 + 120.0 165.0 -0.49787 + 135.0 165.0 -0.79017 + 150.0 165.0 -0.50914 + 165.0 165.0 0.18602 + 180.0 165.0 0.76902 + -180.0 180.0 0.98936 + -165.0 180.0 0.76408 + -150.0 180.0 0.21674 + -135.0 180.0 -0.182 + -120.0 180.0 -0.37729 + -105.0 180.0 -0.47834 + -90.0 180.0 -0.59267 + -75.0 180.0 -0.93985 + -60.0 180.0 -1.55558 + -45.0 180.0 -2.01849 + -30.0 180.0 -1.94076 + -15.0 180.0 -1.464 + 0.0 180.0 0.18253 + 15.0 180.0 -0.80364 + 30.0 180.0 -1.32974 + 45.0 180.0 -1.31658 + 60.0 180.0 -0.5014 + 75.0 180.0 0.20431 + 90.0 180.0 0.39356 + 105.0 180.0 0.20356 + 120.0 180.0 -0.16993 + 135.0 180.0 -0.22733 + 150.0 180.0 0.13703 + 165.0 180.0 0.66356 + 180.0 180.0 0.98936 diff --git a/examples/amoeba/data.ubiquitin b/examples/amoeba/data.ubiquitin index 05a0673ce8..2e4836880a 100644 --- a/examples/amoeba/data.ubiquitin +++ b/examples/amoeba/data.ubiquitin @@ -14,6 +14,7 @@ LAMMPS data file created from Tinker ubiquitin.xyz and amoeba_ubiquitin.prm file 0 41.91 ylo yhi 0 41.91 zlo zhi 6 pitorsion types +106 bitorsions 106 pitorsions Masses @@ -26348,6 +26349,80 @@ UreyBradley Coeffs 110 0.0 0.0 111 -7.6 1.5537 +BiTorsions + +1 1 3 20 21 22 37 +2 1 22 37 38 39 56 +3 1 39 56 57 58 76 +4 1 58 76 77 78 92 +5 1 78 92 93 94 114 +6 1 94 114 115 116 128 +7 1 116 128 129 130 147 +8 1 130 147 148 149 161 +9 2 149 161 162 163 168 +10 1 163 168 169 170 190 +11 1 170 190 191 192 204 +12 1 192 204 205 206 223 +13 1 206 223 224 225 237 +14 1 225 237 238 239 256 +15 1 239 256 257 258 271 +16 1 258 271 272 273 287 +17 3 273 287 288 289 302 +18 1 304 316 317 318 327 +19 1 318 327 328 329 339 +20 1 329 339 340 341 353 +21 1 341 353 354 355 372 +22 1 355 372 373 374 387 +23 1 374 387 388 389 401 +24 1 389 401 402 403 417 +25 1 403 417 418 419 439 +26 1 419 439 440 441 449 +27 1 441 449 450 451 471 +28 1 451 471 472 473 490 +29 1 473 490 491 492 507 +30 1 492 507 508 509 519 +31 1 509 519 520 521 541 +32 1 521 541 542 543 556 +33 2 543 556 557 558 563 +34 3 558 563 564 565 582 +35 1 598 610 611 612 622 +36 1 612 622 623 624 639 +37 1 624 639 640 641 656 +38 1 641 656 657 658 680 +39 1 658 680 681 682 699 +40 1 682 699 700 701 718 +41 1 701 718 719 720 738 +42 1 720 738 739 740 748 +43 2 740 748 749 750 755 +44 1 750 755 756 757 777 +45 1 757 777 778 779 794 +46 1 779 794 795 796 813 +47 1 796 813 814 815 828 +48 1 815 828 829 830 840 +49 2 830 840 841 842 847 +50 1 842 847 848 849 871 +51 1 849 871 872 873 885 +52 1 873 885 886 887 904 +53 1 887 904 905 906 915 +54 1 906 915 916 917 927 +55 1 917 927 928 929 948 +56 1 929 948 949 950 962 +57 1 950 962 963 964 981 +58 1 964 981 982 983 998 +59 1 983 998 999 1000 1020 +60 1 1000 1020 1021 1022 1035 +61 1 1022 1035 1036 1037 1046 +62 1 1037 1046 1047 1048 1060 +63 1 1048 1060 1061 1062 1079 +64 1 1062 1079 1080 1081 1097 +65 1 1081 1097 1098 1099 1116 +66 1 1099 1116 1117 1118 1132 +67 1 1118 1132 1133 1134 1151 +68 1 1134 1151 1152 1153 1175 +69 1 1153 1175 1176 1177 1194 +70 1 1177 1194 1195 1196 1218 +71 2 1196 1218 1219 1220 1225 + PiTorsions 1 1 2 4 3 20 21 24 diff --git a/examples/amoeba/in.ubiquitin b/examples/amoeba/in.ubiquitin index 8603398ac0..f53a3c87c8 100644 --- a/examples/amoeba/in.ubiquitin +++ b/examples/amoeba/in.ubiquitin @@ -16,6 +16,8 @@ improper_style amoeba fix amtype all property/atom i_amtype ghost yes fix pitorsion all pitorsion fix_modify pitorsion energy yes +fix bitorsion all bitorsion bitorsion.ubiquitin.data +fix_modify bitorsion energy yes fix extra all property/atom & i_amgroup i_ired i_xaxis i_yaxis i_zaxis d_pval ghost yes @@ -26,7 +28,7 @@ read_data data.ubiquitin fix amtype NULL "Tinker Types" & fix pitorsion "pitorsion types" "PiTorsion Coeffs" & fix pitorsion pitorsions PiTorsions -pair_style amoeba +pair_style amoeba include bitorsion pair_coeff * * amoeba_ubiquitin.prm amoeba_ubiquitin.key special_bonds lj/coul 0.5 0.5 0.5 one/five yes diff --git a/src/AMOEBA/fix_bitorsion.cpp b/src/AMOEBA/fix_bitorsion.cpp index 2fe63c08dd..44669cb68e 100644 --- a/src/AMOEBA/fix_bitorsion.cpp +++ b/src/AMOEBA/fix_bitorsion.cpp @@ -35,6 +35,7 @@ using namespace MathConst; #define BITORSIONMAX 6 // max # of BiTorsion terms stored by one atom #define LISTDELTA 10000 #define LB_FACTOR 1.5 +#define MAXLINE 1024 // NOTE: extra until figure things out @@ -106,7 +107,7 @@ FixBiTorsion::FixBiTorsion(LAMMPS *lmp, int narg, char **arg) : // read and setup BiTorsion grid data - read_grid_map(arg[3]); + read_grid_data(arg[3]); // perform initial allocation of atom-based arrays @@ -130,6 +131,12 @@ FixBiTorsion::FixBiTorsion(LAMMPS *lmp, int narg, char **arg) : nbitorsion_list = 0; max_bitorsion_list = 0; bitorsion_list = nullptr; + + // BiTorsion grid data + + ntypes = 0; + nxgrid,nygrid = nullptr; + btgrid = nullptr; } /* --------------------------------------------------------------------- */ @@ -154,6 +161,14 @@ FixBiTorsion::~FixBiTorsion() // local list of bitorsions to compute memory->destroy(bitorsion_list); + + // BiTorsion grid data + + delete [] nxgrid; + delete [] nygrid; + for (int itype = 0; itype < ntypes; itype++) + memory->destroy(btgrid[itype]); + delete [] btgrid; } /* ---------------------------------------------------------------------- */ @@ -679,47 +694,92 @@ double FixBiTorsion::compute_scalar() // ---------------------------------------------------------------------- // ---------------------------------------------------------------------- -// methods to read BiTorsion potential file, perform interpolation +// methods to read BiTorsion grid file, perform interpolation // ---------------------------------------------------------------------- // ---------------------------------------------------------------------- -void FixBiTorsion::read_grid_map(char *bitorsion_file) +void FixBiTorsion::read_grid_data(char *bitorsion_file) { - int MAXLINE = 1024; - char linebuf[MAXLINE]; - char *chunk,*line; - int i1, i2, i3, i4, i5, i6, j1, j2, j3, j4, j5, j6, counter; + char line[MAXLINE]; + char *eof; FILE *fp = nullptr; if (me == 0) { fp = utils::open_potential(bitorsion_file,lmp,nullptr); if (fp == nullptr) - error->one(FLERR,"Cannot open fix cmap file {}: {}", + error->one(FLERR,"Cannot open fix bitorsion file {}: {}", bitorsion_file, utils::getsyserror()); + eof = fgets(line,MAXLINE,fp); + eof = fgets(line,MAXLINE,fp); + eof = fgets(line,MAXLINE,fp); + if (eof == nullptr) error->one(FLERR,"Unexpected end of fix bitorsion file"); + + sscanf(line,"%d",&ntypes); } - int done; + MPI_Bcast(&ntypes,1,MPI_INT,0,world); + if (ntypes == 0) error->all(FLERR,"Fix bitorsion file has no types"); - while (!done) { - // only read on rank 0 and broadcast to all other ranks - if (me == 0) - done = (fgets(linebuf,MAXLINE,fp) == nullptr); + btgrid = new double***[ntypes]; + nxgrid = new int[ntypes]; + nygrid = new int[ntypes]; - MPI_Bcast(&done,1,MPI_INT,0,world); - if (done) continue; + // read one array for each BiTorsion type from file - MPI_Bcast(linebuf,MAXLINE,MPI_CHAR,0,world); + int tmp,nx,ny; + double xgrid,ygrid,value; - // remove leading whitespace - line = linebuf; - while (line && (*line == ' ' || *line == '\t' || *line == '\r')) ++line; + for (int itype = 0; itype < ntypes; itype++) { + if (me == 0) { + eof = fgets(line,MAXLINE,fp); + eof = fgets(line,MAXLINE,fp); + if (eof == nullptr) + error->one(FLERR,"Unexpected end of fix bitorsion file"); + sscanf(line,"%d %d %d",&tmp,&nx,&ny); + } - // skip if empty line or comment - if (!line || *line =='\n' || *line == '\0' || *line == '#') continue; + MPI_Bcast(&nx,1,MPI_INT,0,world); + MPI_Bcast(&ny,1,MPI_INT,0,world); + nxgrid[itype] = nx; + nygrid[itype] = ny; + + memory->create(btgrid[itype],nx,ny,3,"bitorsion:btgrid"); + + // NOTE: should read this chunk of lines with utils in single read + + if (me == 0) { + for (int iy = 0; iy < ny; iy++) { + for (int ix = 0; ix < nx; ix++) { + eof = fgets(line,MAXLINE,fp); + if (eof == nullptr) + error->one(FLERR,"Unexpected end of fix bitorsion file"); + sscanf(line,"%lg %lg %lg",&xgrid,&ygrid,&value); + btgrid[itype][ix][iy][0] = xgrid; + btgrid[itype][ix][iy][1] = ygrid; + btgrid[itype][ix][iy][2] = value; + } + } + } + + MPI_Bcast(&btgrid[itype][0][0][0],nx*ny*3,MPI_DOUBLE,0,world); } if (me == 0) fclose(fp); + + // DEBUG + + for (int i = 0; i < ntypes; i++) { + printf("ITYPE %d NXY %d %d\n",i+1,nxgrid[i],nygrid[i]); + for (int iy = 0; iy < ny; iy++) { + for (int ix = 0; ix < nx; ix++) { + printf(" IXY %d %d, values %g %g %g\n",ix+1,iy+1, + btgrid[i][ix][iy][0], + btgrid[i][ix][iy][1], + btgrid[i][ix][iy][2]); + } + } + } } // ---------------------------------------------------------------------- diff --git a/src/AMOEBA/fix_bitorsion.h b/src/AMOEBA/fix_bitorsion.h index 0ed072f37c..1bc5fc1012 100644 --- a/src/AMOEBA/fix_bitorsion.h +++ b/src/AMOEBA/fix_bitorsion.h @@ -90,9 +90,15 @@ class FixBiTorsion : public Fix { int max_bitorsion_list; int **bitorsion_list; + // BiTorsion grid data + + int ntypes; + int *nxgrid,*nygrid; + double ****btgrid; + // read BiTorsion grid data - void read_grid_map(char *); + void read_grid_data(char *); }; } // namespace LAMMPS_NS diff --git a/src/modify.cpp b/src/modify.cpp index ef738ecc67..07d5b8ee9b 100644 --- a/src/modify.cpp +++ b/src/modify.cpp @@ -810,7 +810,7 @@ Fix *Modify::add_fix(int narg, char **arg, int trysuffix) const char *exceptions[] = {"GPU", "OMP", "INTEL", "property/atom", "cmap", "cmap3", "rx", - "deprecated", "STORE/KIM", "pitorsion", nullptr}; + "deprecated", "STORE/KIM", "pitorsion", "bitorsion", nullptr}; if (domain->box_exist == 0) { int m; From 7a32832b88095865b3536827af441170ddc0655e Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Tue, 15 Mar 2022 09:35:42 -0600 Subject: [PATCH 090/585] bug fixes --- examples/amoeba/data.ubiquitin | 2 +- examples/amoeba/in.ubiquitin | 7 ++++--- src/AMOEBA/fix_bitorsion.cpp | 34 +++++++++------------------------- src/AMOEBA/fix_pitorsion.cpp | 4 ++++ tools/tinker/tinker2lmp.py | 2 +- 5 files changed, 19 insertions(+), 30 deletions(-) diff --git a/examples/amoeba/data.ubiquitin b/examples/amoeba/data.ubiquitin index 2e4836880a..6b51695efb 100644 --- a/examples/amoeba/data.ubiquitin +++ b/examples/amoeba/data.ubiquitin @@ -14,7 +14,7 @@ LAMMPS data file created from Tinker ubiquitin.xyz and amoeba_ubiquitin.prm file 0 41.91 ylo yhi 0 41.91 zlo zhi 6 pitorsion types -106 bitorsions +71 bitorsions 106 pitorsions Masses diff --git a/examples/amoeba/in.ubiquitin b/examples/amoeba/in.ubiquitin index f53a3c87c8..dbf544b402 100644 --- a/examples/amoeba/in.ubiquitin +++ b/examples/amoeba/in.ubiquitin @@ -26,9 +26,10 @@ fix extra2 all property/atom i_polaxe #read_data data.ubiquitin fix amtype NULL "Tinker Types" read_data data.ubiquitin fix amtype NULL "Tinker Types" & fix pitorsion "pitorsion types" "PiTorsion Coeffs" & - fix pitorsion pitorsions PiTorsions + fix pitorsion pitorsions PiTorsions & + fix bitorsion bitorsions BiTorsions -pair_style amoeba include bitorsion +pair_style amoeba exclude bitorsion pair_coeff * * amoeba_ubiquitin.prm amoeba_ubiquitin.key special_bonds lj/coul 0.5 0.5 0.5 one/five yes @@ -38,7 +39,7 @@ special_bonds lj/coul 0.5 0.5 0.5 one/five yes compute virial all pressure NULL virial thermo_style custom step temp epair ebond eangle edihed eimp & - emol etotal press c_virial[*] + emol etotal #press c_virial[*] # zero step run diff --git a/src/AMOEBA/fix_bitorsion.cpp b/src/AMOEBA/fix_bitorsion.cpp index 44669cb68e..a1bb149872 100644 --- a/src/AMOEBA/fix_bitorsion.cpp +++ b/src/AMOEBA/fix_bitorsion.cpp @@ -132,11 +132,9 @@ FixBiTorsion::FixBiTorsion(LAMMPS *lmp, int narg, char **arg) : max_bitorsion_list = 0; bitorsion_list = nullptr; - // BiTorsion grid data + // zero thermo energy - ntypes = 0; - nxgrid,nygrid = nullptr; - btgrid = nullptr; + ebitorsion = 0.0; } /* --------------------------------------------------------------------- */ @@ -166,7 +164,7 @@ FixBiTorsion::~FixBiTorsion() delete [] nxgrid; delete [] nygrid; - for (int itype = 0; itype < ntypes; itype++) + for (int itype = 1; itype <= ntypes; itype++) memory->destroy(btgrid[itype]); delete [] btgrid; } @@ -304,7 +302,7 @@ void FixBiTorsion::pre_neighbor() bitorsion_list[nbitorsion_list][2] = atom3; bitorsion_list[nbitorsion_list][3] = atom4; bitorsion_list[nbitorsion_list][4] = atom5; - bitorsion_list[nbitorsion_list][6] = bitorsion_type[i][m]; + bitorsion_list[nbitorsion_list][5] = bitorsion_type[i][m]; nbitorsion_list++; } } @@ -399,7 +397,7 @@ void FixBiTorsion::post_force(int vflag) id = bitorsion_list[n][3]; ie = bitorsion_list[n][4]; - // NOTE: is a btype ever needed, maybe as index into spline tables? + // NOTE: is a btype ever used, i.e. as index into spline tables? btype = bitorsion_list[n][5]; @@ -721,16 +719,16 @@ void FixBiTorsion::read_grid_data(char *bitorsion_file) MPI_Bcast(&ntypes,1,MPI_INT,0,world); if (ntypes == 0) error->all(FLERR,"Fix bitorsion file has no types"); - btgrid = new double***[ntypes]; - nxgrid = new int[ntypes]; - nygrid = new int[ntypes]; + btgrid = new double***[ntypes+1]; + nxgrid = new int[ntypes+1]; + nygrid = new int[ntypes+1]; // read one array for each BiTorsion type from file int tmp,nx,ny; double xgrid,ygrid,value; - for (int itype = 0; itype < ntypes; itype++) { + for (int itype = 1; itype <= ntypes; itype++) { if (me == 0) { eof = fgets(line,MAXLINE,fp); eof = fgets(line,MAXLINE,fp); @@ -766,20 +764,6 @@ void FixBiTorsion::read_grid_data(char *bitorsion_file) } if (me == 0) fclose(fp); - - // DEBUG - - for (int i = 0; i < ntypes; i++) { - printf("ITYPE %d NXY %d %d\n",i+1,nxgrid[i],nygrid[i]); - for (int iy = 0; iy < ny; iy++) { - for (int ix = 0; ix < nx; ix++) { - printf(" IXY %d %d, values %g %g %g\n",ix+1,iy+1, - btgrid[i][ix][iy][0], - btgrid[i][ix][iy][1], - btgrid[i][ix][iy][2]); - } - } - } } // ---------------------------------------------------------------------- diff --git a/src/AMOEBA/fix_pitorsion.cpp b/src/AMOEBA/fix_pitorsion.cpp index b66ffa0525..689097df99 100644 --- a/src/AMOEBA/fix_pitorsion.cpp +++ b/src/AMOEBA/fix_pitorsion.cpp @@ -95,6 +95,10 @@ FixPiTorsion::FixPiTorsion(LAMMPS *lmp, int narg, char **arg) : // pitorsion coeff kpit = nullptr; + + // zero thermo energy + + epitorsion = 0.0; } /* --------------------------------------------------------------------- */ diff --git a/tools/tinker/tinker2lmp.py b/tools/tinker/tinker2lmp.py index b09ec6e031..fec9f8a506 100644 --- a/tools/tinker/tinker2lmp.py +++ b/tools/tinker/tinker2lmp.py @@ -1384,7 +1384,7 @@ if npitorsions: d.sections["PiTorsions"] = lines if nbitorsions: - d.headers["bitorsions"] = len(pitorsionlist) + d.headers["bitorsions"] = len(bitorsionlist) # if there are bitorsions, then -bitorsion file must have been specified From ab82590437c4170212ac85941acbcb1fdefc21de Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Tue, 15 Mar 2022 13:40:29 -0600 Subject: [PATCH 091/585] change name of 2 new fixes to include amoeba --- examples/amoeba/in.ubiquitin | 14 +-- ...bitorsion.cpp => fix_amoeba_bitorsion.cpp} | 88 ++++++++++--------- ...fix_bitorsion.h => fix_amoeba_bitorsion.h} | 12 +-- ...pitorsion.cpp => fix_amoeba_pitorsion.cpp} | 80 ++++++++--------- ...fix_pitorsion.h => fix_amoeba_pitorsion.h} | 12 +-- src/modify.cpp | 3 +- 6 files changed, 106 insertions(+), 103 deletions(-) rename src/AMOEBA/{fix_bitorsion.cpp => fix_amoeba_bitorsion.cpp} (92%) rename src/AMOEBA/{fix_bitorsion.h => fix_amoeba_bitorsion.h} (92%) rename src/AMOEBA/{fix_pitorsion.cpp => fix_amoeba_pitorsion.cpp} (93%) rename src/AMOEBA/{fix_pitorsion.h => fix_amoeba_pitorsion.h} (92%) diff --git a/examples/amoeba/in.ubiquitin b/examples/amoeba/in.ubiquitin index dbf544b402..4d5e341bcd 100644 --- a/examples/amoeba/in.ubiquitin +++ b/examples/amoeba/in.ubiquitin @@ -14,10 +14,10 @@ improper_style amoeba # per-atom properties required by AMOEBA or HIPPO fix amtype all property/atom i_amtype ghost yes -fix pitorsion all pitorsion -fix_modify pitorsion energy yes -fix bitorsion all bitorsion bitorsion.ubiquitin.data -fix_modify bitorsion energy yes +fix pit all amoeba/pitorsion +fix_modify pit energy yes +fix bit all amoeba/bitorsion bitorsion.ubiquitin.data +fix_modify bit energy yes fix extra all property/atom & i_amgroup i_ired i_xaxis i_yaxis i_zaxis d_pval ghost yes @@ -25,9 +25,9 @@ fix extra2 all property/atom i_polaxe #read_data data.ubiquitin fix amtype NULL "Tinker Types" read_data data.ubiquitin fix amtype NULL "Tinker Types" & - fix pitorsion "pitorsion types" "PiTorsion Coeffs" & - fix pitorsion pitorsions PiTorsions & - fix bitorsion bitorsions BiTorsions + fix pit "pitorsion types" "PiTorsion Coeffs" & + fix pit pitorsions PiTorsions & + fix bit bitorsions BiTorsions pair_style amoeba exclude bitorsion pair_coeff * * amoeba_ubiquitin.prm amoeba_ubiquitin.key diff --git a/src/AMOEBA/fix_bitorsion.cpp b/src/AMOEBA/fix_amoeba_bitorsion.cpp similarity index 92% rename from src/AMOEBA/fix_bitorsion.cpp rename to src/AMOEBA/fix_amoeba_bitorsion.cpp index a1bb149872..e9ff52a0b7 100644 --- a/src/AMOEBA/fix_bitorsion.cpp +++ b/src/AMOEBA/fix_amoeba_bitorsion.cpp @@ -12,7 +12,7 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include "fix_bitorsion.h" +#include "fix_amoeba_bitorsion.h" #include @@ -78,13 +78,13 @@ void bcuint1(double *ftt, double *ft1, double *ft2, double *ft12, /* ---------------------------------------------------------------------- */ -FixBiTorsion::FixBiTorsion(LAMMPS *lmp, int narg, char **arg) : +FixAmoebaBiTorsion::FixAmoebaBiTorsion(LAMMPS *lmp, int narg, char **arg) : Fix(lmp, narg, arg), bitorsion_list(nullptr), num_bitorsion(nullptr), bitorsion_type(nullptr), bitorsion_atom1(nullptr), bitorsion_atom2(nullptr), bitorsion_atom3(nullptr), bitorsion_atom4(nullptr), bitorsion_atom5(nullptr) { - if (narg != 4) error->all(FLERR,"Illegal fix bitorsion command"); + if (narg != 4) error->all(FLERR,"Illegal fix amoeba/bitorsion command"); restart_global = 1; restart_peratom = 1; @@ -139,7 +139,7 @@ FixBiTorsion::FixBiTorsion(LAMMPS *lmp, int narg, char **arg) : /* --------------------------------------------------------------------- */ -FixBiTorsion::~FixBiTorsion() +FixAmoebaBiTorsion::~FixAmoebaBiTorsion() { // unregister callbacks to this fix from Atom class @@ -171,7 +171,7 @@ FixBiTorsion::~FixBiTorsion() /* ---------------------------------------------------------------------- */ -int FixBiTorsion::setmask() +int FixAmoebaBiTorsion::setmask() { int mask = 0; mask |= PRE_NEIGHBOR; @@ -184,7 +184,7 @@ int FixBiTorsion::setmask() /* ---------------------------------------------------------------------- */ -void FixBiTorsion::init() +void FixAmoebaBiTorsion::init() { if (utils::strmatch(update->integrate_style,"^respa")) { ilevel_respa = ((Respa *) update->integrate)->nlevels-1; @@ -209,7 +209,7 @@ void FixBiTorsion::init() /* --------------------------------------------------------------------- */ -void FixBiTorsion::setup(int vflag) +void FixAmoebaBiTorsion::setup(int vflag) { pre_neighbor(); @@ -224,21 +224,21 @@ void FixBiTorsion::setup(int vflag) /* --------------------------------------------------------------------- */ -void FixBiTorsion::setup_pre_neighbor() +void FixAmoebaBiTorsion::setup_pre_neighbor() { pre_neighbor(); } /* --------------------------------------------------------------------- */ -void FixBiTorsion::setup_pre_reverse(int eflag, int vflag) +void FixAmoebaBiTorsion::setup_pre_reverse(int eflag, int vflag) { pre_reverse(eflag,vflag); } /* --------------------------------------------------------------------- */ -void FixBiTorsion::min_setup(int vflag) +void FixAmoebaBiTorsion::min_setup(int vflag) { pre_neighbor(); post_force(vflag); @@ -250,7 +250,7 @@ void FixBiTorsion::min_setup(int vflag) this proc lists the bitorsion exactly once ------------------------------------------------------------------------- */ -void FixBiTorsion::pre_neighbor() +void FixAmoebaBiTorsion::pre_neighbor() { int i,m,atom1,atom2,atom3,atom4,atom5; @@ -313,14 +313,14 @@ void FixBiTorsion::pre_neighbor() store eflag, so can use it in post_force to tally per-atom energies ------------------------------------------------------------------------- */ -void FixBiTorsion::pre_reverse(int eflag, int /*vflag*/) +void FixAmoebaBiTorsion::pre_reverse(int eflag, int /*vflag*/) { eflag_caller = eflag; } /* ---------------------------------------------------------------------- */ -void FixBiTorsion::post_force(int vflag) +void FixAmoebaBiTorsion::post_force(int vflag) { if (disable) return; @@ -667,14 +667,14 @@ void FixBiTorsion::post_force(int vflag) /* ---------------------------------------------------------------------- */ -void FixBiTorsion::post_force_respa(int vflag, int ilevel, int /*iloop*/) +void FixAmoebaBiTorsion::post_force_respa(int vflag, int ilevel, int /*iloop*/) { if (ilevel == ilevel_respa) post_force(vflag); } /* ---------------------------------------------------------------------- */ -void FixBiTorsion::min_post_force(int vflag) +void FixAmoebaBiTorsion::min_post_force(int vflag) { post_force(vflag); } @@ -683,7 +683,7 @@ void FixBiTorsion::min_post_force(int vflag) energy of BiTorision term ------------------------------------------------------------------------- */ -double FixBiTorsion::compute_scalar() +double FixAmoebaBiTorsion::compute_scalar() { double all; MPI_Allreduce(&ebitorsion,&all,1,MPI_DOUBLE,MPI_SUM,world); @@ -696,7 +696,7 @@ double FixBiTorsion::compute_scalar() // ---------------------------------------------------------------------- // ---------------------------------------------------------------------- -void FixBiTorsion::read_grid_data(char *bitorsion_file) +void FixAmoebaBiTorsion::read_grid_data(char *bitorsion_file) { char line[MAXLINE]; char *eof; @@ -705,19 +705,20 @@ void FixBiTorsion::read_grid_data(char *bitorsion_file) if (me == 0) { fp = utils::open_potential(bitorsion_file,lmp,nullptr); if (fp == nullptr) - error->one(FLERR,"Cannot open fix bitorsion file {}: {}", + error->one(FLERR,"Cannot open fix amoeba/bitorsion file {}: {}", bitorsion_file, utils::getsyserror()); eof = fgets(line,MAXLINE,fp); eof = fgets(line,MAXLINE,fp); eof = fgets(line,MAXLINE,fp); - if (eof == nullptr) error->one(FLERR,"Unexpected end of fix bitorsion file"); + if (eof == nullptr) + error->one(FLERR,"Unexpected end of fix amoeba/bitorsion file"); sscanf(line,"%d",&ntypes); } MPI_Bcast(&ntypes,1,MPI_INT,0,world); - if (ntypes == 0) error->all(FLERR,"Fix bitorsion file has no types"); + if (ntypes == 0) error->all(FLERR,"Fix amoeba/bitorsion file has no types"); btgrid = new double***[ntypes+1]; nxgrid = new int[ntypes+1]; @@ -733,7 +734,7 @@ void FixBiTorsion::read_grid_data(char *bitorsion_file) eof = fgets(line,MAXLINE,fp); eof = fgets(line,MAXLINE,fp); if (eof == nullptr) - error->one(FLERR,"Unexpected end of fix bitorsion file"); + error->one(FLERR,"Unexpected end of fix amoeba/bitorsion file"); sscanf(line,"%d %d %d",&tmp,&nx,&ny); } @@ -751,7 +752,7 @@ void FixBiTorsion::read_grid_data(char *bitorsion_file) for (int ix = 0; ix < nx; ix++) { eof = fgets(line,MAXLINE,fp); if (eof == nullptr) - error->one(FLERR,"Unexpected end of fix bitorsion file"); + error->one(FLERR,"Unexpected end of fix amoeba/bitorsion file"); sscanf(line,"%lg %lg %lg",&xgrid,&ygrid,&value); btgrid[itype][ix][iy][0] = xgrid; btgrid[itype][ix][iy][1] = ygrid; @@ -772,11 +773,12 @@ void FixBiTorsion::read_grid_data(char *bitorsion_file) // ---------------------------------------------------------------------- // ---------------------------------------------------------------------- -void FixBiTorsion::read_data_header(char *line) +void FixAmoebaBiTorsion::read_data_header(char *line) { if (strstr(line,"bitorsions")) { sscanf(line,BIGINT_FORMAT,&nbitorsions); - } else error->all(FLERR,"Invalid read data header line for fix bitorsion"); + } else error->all(FLERR, + "Invalid read data header line for fix amoeba/bitorsion"); } /* ---------------------------------------------------------------------- @@ -784,7 +786,7 @@ void FixBiTorsion::read_data_header(char *line) id_offset is applied to atomID fields if multiple data files are read ------------------------------------------------------------------------- */ -void FixBiTorsion::read_data_section(char *keyword, int n, char *buf, +void FixAmoebaBiTorsion::read_data_section(char *keyword, int n, char *buf, tagint id_offset) { int m,tmp,itype; @@ -882,7 +884,7 @@ void FixBiTorsion::read_data_section(char *keyword, int n, char *buf, /* ---------------------------------------------------------------------- */ -bigint FixBiTorsion::read_data_skip_lines(char * /*keyword*/) +bigint FixAmoebaBiTorsion::read_data_skip_lines(char * /*keyword*/) { return nbitorsions; } @@ -892,7 +894,7 @@ bigint FixBiTorsion::read_data_skip_lines(char * /*keyword*/) only called by proc 0 ------------------------------------------------------------------------- */ -void FixBiTorsion::write_data_header(FILE *fp, int /*mth*/) +void FixAmoebaBiTorsion::write_data_header(FILE *fp, int /*mth*/) { fprintf(fp,BIGINT_FORMAT " bitorsions\n",nbitorsions); } @@ -905,7 +907,7 @@ void FixBiTorsion::write_data_header(FILE *fp, int /*mth*/) // ny = 6 columns = type + 5 atom IDs ------------------------------------------------------------------------- */ -void FixBiTorsion::write_data_section_size(int /*mth*/, int &nx, int &ny) +void FixAmoebaBiTorsion::write_data_section_size(int /*mth*/, int &nx, int &ny) { int i,m; @@ -925,7 +927,7 @@ void FixBiTorsion::write_data_section_size(int /*mth*/, int &nx, int &ny) buf allocated by caller as owned BiTorsions by 6 ------------------------------------------------------------------------- */ -void FixBiTorsion::write_data_section_pack(int /*mth*/, double **buf) +void FixAmoebaBiTorsion::write_data_section_pack(int /*mth*/, double **buf) { int i,m; @@ -956,7 +958,7 @@ void FixBiTorsion::write_data_section_pack(int /*mth*/, double **buf) only called by proc 0 ------------------------------------------------------------------------- */ -void FixBiTorsion::write_data_section_keyword(int /*mth*/, FILE *fp) +void FixAmoebaBiTorsion::write_data_section_keyword(int /*mth*/, FILE *fp) { fprintf(fp,"\nBiTorsions\n\n"); } @@ -968,7 +970,7 @@ void FixBiTorsion::write_data_section_keyword(int /*mth*/, FILE *fp) only called by proc 0 ------------------------------------------------------------------------- */ -void FixBiTorsion::write_data_section(int /*mth*/, FILE *fp, +void FixAmoebaBiTorsion::write_data_section(int /*mth*/, FILE *fp, int n, double **buf, int index) { for (int i = 0; i < n; i++) @@ -989,7 +991,7 @@ void FixBiTorsion::write_data_section(int /*mth*/, FILE *fp, pack entire state of Fix into one write ------------------------------------------------------------------------- */ -void FixBiTorsion::write_restart(FILE *fp) +void FixAmoebaBiTorsion::write_restart(FILE *fp) { if (comm->me == 0) { int size = sizeof(bigint); @@ -1002,7 +1004,7 @@ void FixBiTorsion::write_restart(FILE *fp) use state info from restart file to restart the Fix ------------------------------------------------------------------------- */ -void FixBiTorsion::restart(char *buf) +void FixAmoebaBiTorsion::restart(char *buf) { nbitorsions = *((bigint *) buf); } @@ -1011,7 +1013,7 @@ void FixBiTorsion::restart(char *buf) pack values in local atom-based arrays for restart file ------------------------------------------------------------------------- */ -int FixBiTorsion::pack_restart(int i, double *buf) +int FixAmoebaBiTorsion::pack_restart(int i, double *buf) { int n = 1; for (int m = 0; m < num_bitorsion[i]; m++) { @@ -1031,7 +1033,7 @@ int FixBiTorsion::pack_restart(int i, double *buf) unpack values from atom->extra array to restart the fix ------------------------------------------------------------------------- */ -void FixBiTorsion::unpack_restart(int nlocal, int nth) +void FixAmoebaBiTorsion::unpack_restart(int nlocal, int nth) { double **extra = atom->extra; @@ -1058,7 +1060,7 @@ void FixBiTorsion::unpack_restart(int nlocal, int nth) maxsize of any atom's restart data ------------------------------------------------------------------------- */ -int FixBiTorsion::maxsize_restart() +int FixAmoebaBiTorsion::maxsize_restart() { return 1 + BITORSIONMAX*6; } @@ -1067,7 +1069,7 @@ int FixBiTorsion::maxsize_restart() size of atom nlocal's restart data ------------------------------------------------------------------------- */ -int FixBiTorsion::size_restart(int nlocal) +int FixAmoebaBiTorsion::size_restart(int nlocal) { return 1 + num_bitorsion[nlocal]*6; } @@ -1076,7 +1078,7 @@ int FixBiTorsion::size_restart(int nlocal) allocate atom-based array ------------------------------------------------------------------------- */ -void FixBiTorsion::grow_arrays(int nmax) +void FixAmoebaBiTorsion::grow_arrays(int nmax) { num_bitorsion = memory->grow(num_bitorsion,nmax,"cmap:num_bitorsion"); bitorsion_type = memory->grow(bitorsion_type,nmax,BITORSIONMAX, @@ -1103,7 +1105,7 @@ void FixBiTorsion::grow_arrays(int nmax) copy values within local atom-based array ------------------------------------------------------------------------- */ -void FixBiTorsion::copy_arrays(int i, int j, int /*delflag*/) +void FixAmoebaBiTorsion::copy_arrays(int i, int j, int /*delflag*/) { num_bitorsion[j] = num_bitorsion[i]; @@ -1121,7 +1123,7 @@ void FixBiTorsion::copy_arrays(int i, int j, int /*delflag*/) initialize one atom's array values, called when atom is created ------------------------------------------------------------------------- */ -void FixBiTorsion::set_arrays(int i) +void FixAmoebaBiTorsion::set_arrays(int i) { num_bitorsion[i] = 0; } @@ -1130,7 +1132,7 @@ void FixBiTorsion::set_arrays(int i) pack values in local atom-based array for exchange with another proc ------------------------------------------------------------------------- */ -int FixBiTorsion::pack_exchange(int i, double *buf) +int FixAmoebaBiTorsion::pack_exchange(int i, double *buf) { int n = 0; buf[n++] = ubuf(num_bitorsion[i]).d; @@ -1149,7 +1151,7 @@ int FixBiTorsion::pack_exchange(int i, double *buf) unpack values in local atom-based array from exchange with another proc ------------------------------------------------------------------------- */ -int FixBiTorsion::unpack_exchange(int nlocal, double *buf) +int FixAmoebaBiTorsion::unpack_exchange(int nlocal, double *buf) { int n = 0; num_bitorsion[nlocal] = (int) ubuf(buf[n++]).i; @@ -1168,7 +1170,7 @@ int FixBiTorsion::unpack_exchange(int nlocal, double *buf) memory usage of local atom-based arrays ------------------------------------------------------------------------- */ -double FixBiTorsion::memory_usage() +double FixAmoebaBiTorsion::memory_usage() { int nmax = atom->nmax; double bytes = (double)nmax * sizeof(int); // num_bitorsion diff --git a/src/AMOEBA/fix_bitorsion.h b/src/AMOEBA/fix_amoeba_bitorsion.h similarity index 92% rename from src/AMOEBA/fix_bitorsion.h rename to src/AMOEBA/fix_amoeba_bitorsion.h index 1bc5fc1012..49af5cc95d 100644 --- a/src/AMOEBA/fix_bitorsion.h +++ b/src/AMOEBA/fix_amoeba_bitorsion.h @@ -13,20 +13,20 @@ #ifdef FIX_CLASS // clang-format off -FixStyle(bitorsion,FixBiTorsion); +FixStyle(amoeba/bitorsion,FixAmoebaBiTorsion); // clang-format on #else -#ifndef LMP_FIX_BITORSION_H -#define LMP_FIX_BITORSION_H +#ifndef LMP_FIX_AMOEBA_BITORSION_H +#define LMP_FIX_AMOEBA_BITORSION_H #include "fix.h" namespace LAMMPS_NS { -class FixBiTorsion : public Fix { +class FixAmoebaBiTorsion : public Fix { public: - FixBiTorsion(class LAMMPS *, int, char **); - ~FixBiTorsion(); + FixAmoebaBiTorsion(class LAMMPS *, int, char **); + ~FixAmoebaBiTorsion(); int setmask(); void init(); void setup(int); diff --git a/src/AMOEBA/fix_pitorsion.cpp b/src/AMOEBA/fix_amoeba_pitorsion.cpp similarity index 93% rename from src/AMOEBA/fix_pitorsion.cpp rename to src/AMOEBA/fix_amoeba_pitorsion.cpp index 689097df99..21f2f957ef 100644 --- a/src/AMOEBA/fix_pitorsion.cpp +++ b/src/AMOEBA/fix_amoeba_pitorsion.cpp @@ -12,7 +12,7 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include "fix_pitorsion.h" +#include "fix_amoeba_pitorsion.h" #include @@ -36,16 +36,15 @@ using namespace MathConst; #define LISTDELTA 8196 #define LB_FACTOR 1.5 - /* ---------------------------------------------------------------------- */ -FixPiTorsion::FixPiTorsion(LAMMPS *lmp, int narg, char **arg) : +FixAmoebaPiTorsion::FixAmoebaPiTorsion(LAMMPS *lmp, int narg, char **arg) : Fix(lmp, narg, arg), pitorsion_list(nullptr), num_pitorsion(nullptr), pitorsion_type(nullptr), pitorsion_atom1(nullptr), pitorsion_atom2(nullptr), pitorsion_atom3(nullptr), pitorsion_atom4(nullptr), pitorsion_atom5(nullptr), pitorsion_atom6(nullptr) { - if (narg != 3) error->all(FLERR,"Illegal fix pitorsion command"); + if (narg != 3) error->all(FLERR,"Illegal fix amoeba/pitorsion command"); // settings for this fix @@ -103,7 +102,7 @@ FixPiTorsion::FixPiTorsion(LAMMPS *lmp, int narg, char **arg) : /* --------------------------------------------------------------------- */ -FixPiTorsion::~FixPiTorsion() +FixAmoebaPiTorsion::~FixAmoebaPiTorsion() { // unregister callbacks to this fix from Atom class @@ -132,7 +131,7 @@ FixPiTorsion::~FixPiTorsion() /* ---------------------------------------------------------------------- */ -int FixPiTorsion::setmask() +int FixAmoebaPiTorsion::setmask() { int mask = 0; mask |= PRE_NEIGHBOR; @@ -145,7 +144,7 @@ int FixPiTorsion::setmask() /* ---------------------------------------------------------------------- */ -void FixPiTorsion::init() +void FixAmoebaPiTorsion::init() { if (utils::strmatch(update->integrate_style,"^respa")) { ilevel_respa = ((Respa *) update->integrate)->nlevels-1; @@ -170,7 +169,7 @@ void FixPiTorsion::init() /* --------------------------------------------------------------------- */ -void FixPiTorsion::setup(int vflag) +void FixAmoebaPiTorsion::setup(int vflag) { pre_neighbor(); @@ -185,21 +184,21 @@ void FixPiTorsion::setup(int vflag) /* --------------------------------------------------------------------- */ -void FixPiTorsion::setup_pre_neighbor() +void FixAmoebaPiTorsion::setup_pre_neighbor() { pre_neighbor(); } /* --------------------------------------------------------------------- */ -void FixPiTorsion::setup_pre_reverse(int eflag, int vflag) +void FixAmoebaPiTorsion::setup_pre_reverse(int eflag, int vflag) { pre_reverse(eflag,vflag); } /* --------------------------------------------------------------------- */ -void FixPiTorsion::min_setup(int vflag) +void FixAmoebaPiTorsion::min_setup(int vflag) { pre_neighbor(); post_force(vflag); @@ -211,7 +210,7 @@ void FixPiTorsion::min_setup(int vflag) this proc lists the pitorsion exactly once ------------------------------------------------------------------------- */ -void FixPiTorsion::pre_neighbor() +void FixAmoebaPiTorsion::pre_neighbor() { int i,m,atom1,atom2,atom3,atom4,atom5,atom6; @@ -278,7 +277,7 @@ void FixPiTorsion::pre_neighbor() store eflag, so can use it in post_force to tally per-atom energies ------------------------------------------------------------------------- */ -void FixPiTorsion::pre_reverse(int eflag, int /*vflag*/) +void FixAmoebaPiTorsion::pre_reverse(int eflag, int /*vflag*/) { eflag_caller = eflag; } @@ -287,7 +286,7 @@ void FixPiTorsion::pre_reverse(int eflag, int /*vflag*/) compute PiTorsion terms ------------------------------------------------------------------------- */ -void FixPiTorsion::post_force(int vflag) +void FixAmoebaPiTorsion::post_force(int vflag) { if (disable) return; @@ -568,14 +567,14 @@ void FixPiTorsion::post_force(int vflag) /* ---------------------------------------------------------------------- */ -void FixPiTorsion::post_force_respa(int vflag, int ilevel, int /*iloop*/) +void FixAmoebaPiTorsion::post_force_respa(int vflag, int ilevel, int /*iloop*/) { if (ilevel == ilevel_respa) post_force(vflag); } /* ---------------------------------------------------------------------- */ -void FixPiTorsion::min_post_force(int vflag) +void FixAmoebaPiTorsion::min_post_force(int vflag) { post_force(vflag); } @@ -584,7 +583,7 @@ void FixPiTorsion::min_post_force(int vflag) energy of PiTorsion term ------------------------------------------------------------------------- */ -double FixPiTorsion::compute_scalar() +double FixAmoebaPiTorsion::compute_scalar() { double all; MPI_Allreduce(&epitorsion,&all,1,MPI_DOUBLE,MPI_SUM,world); @@ -597,13 +596,14 @@ double FixPiTorsion::compute_scalar() // ---------------------------------------------------------------------- // ---------------------------------------------------------------------- -void FixPiTorsion::read_data_header(char *line) +void FixAmoebaPiTorsion::read_data_header(char *line) { if (strstr(line,"pitorsions")) { sscanf(line,BIGINT_FORMAT,&npitorsions); } else if (strstr(line,"pitorsion types")) { sscanf(line,"%d",&npitorsion_types); - } else error->all(FLERR,"Invalid read data header line for fix pitorsion"); + } else error->all(FLERR, + "Invalid read data header line for amoeba/fix pitorsion"); } /* ---------------------------------------------------------------------- @@ -611,7 +611,7 @@ void FixPiTorsion::read_data_header(char *line) id_offset is applied to atomID fields if multiple data files are read ------------------------------------------------------------------------- */ -void FixPiTorsion::read_data_section(char *keyword, int n, char *buf, +void FixAmoebaPiTorsion::read_data_section(char *keyword, int n, char *buf, tagint id_offset) { int which; @@ -622,7 +622,7 @@ void FixPiTorsion::read_data_section(char *keyword, int n, char *buf, } else if (strstr(keyword,"PiTorsion Coeffs")) { sscanf(keyword,"%d",&npitorsion_types); which = 1; - } else error->all(FLERR,"Invalid read data section for fix pitorsion"); + } else error->all(FLERR,"Invalid read data section for fix amoeba/pitorsion"); // loop over lines of PiTorsion Coeffs // tokenize the line into values @@ -640,7 +640,7 @@ void FixPiTorsion::read_data_section(char *keyword, int n, char *buf, *next = '\0'; sscanf(buf,"%d %lg",&itype,&value); if (itype <= 0 || itype > npitorsion_types) - error->all(FLERR,"Incorrect args for pitorsion coefficients"); + error->all(FLERR,"Incorrect args for fix amoeba/pitorsion coeffs"); kpit[itype] = value; buf = next + 1; } @@ -763,7 +763,7 @@ void FixPiTorsion::read_data_section(char *keyword, int n, char *buf, /* ---------------------------------------------------------------------- */ -bigint FixPiTorsion::read_data_skip_lines(char *keyword) +bigint FixAmoebaPiTorsion::read_data_skip_lines(char *keyword) { if (strcmp(keyword,"PiTorsions") == 0) return npitorsions; if (strcmp(keyword,"PiTorsion Coeffs") == 0) return (bigint) npitorsion_types; @@ -775,7 +775,7 @@ bigint FixPiTorsion::read_data_skip_lines(char *keyword) only called by proc 0 ------------------------------------------------------------------------- */ -void FixPiTorsion::write_data_header(FILE *fp, int mth) +void FixAmoebaPiTorsion::write_data_header(FILE *fp, int mth) { if (mth == 0) fprintf(fp,BIGINT_FORMAT " pitorsions\n",npitorsions); else if (mth == 1) @@ -787,7 +787,7 @@ void FixPiTorsion::write_data_header(FILE *fp, int mth) # of data sections = 2 for this fix ------------------------------------------------------------------------- */ -void FixPiTorsion::write_data_section_size(int mth, int &nx, int &ny) +void FixAmoebaPiTorsion::write_data_section_size(int mth, int &nx, int &ny) { int i,m; @@ -824,7 +824,7 @@ void FixPiTorsion::write_data_section_size(int mth, int &nx, int &ny) buf allocated by caller as owned PiTorsions by 7 ------------------------------------------------------------------------- */ -void FixPiTorsion::write_data_section_pack(int mth, double **buf) +void FixAmoebaPiTorsion::write_data_section_pack(int mth, double **buf) { int i,m; @@ -875,7 +875,7 @@ void FixPiTorsion::write_data_section_pack(int mth, double **buf) only called by proc 0 ------------------------------------------------------------------------- */ -void FixPiTorsion::write_data_section_keyword(int mth, FILE *fp) +void FixAmoebaPiTorsion::write_data_section_keyword(int mth, FILE *fp) { if (mth == 0) fprintf(fp,"\nPiTorsions\n\n"); else if (mth == 1) fprintf(fp,"\nPiTorsion Coeffs\n\n"); @@ -888,7 +888,7 @@ void FixPiTorsion::write_data_section_keyword(int mth, FILE *fp) only called by proc 0 ------------------------------------------------------------------------- */ -void FixPiTorsion::write_data_section(int mth, FILE *fp, +void FixAmoebaPiTorsion::write_data_section(int mth, FILE *fp, int n, double **buf, int index) { // PiTorsions section @@ -921,7 +921,7 @@ void FixPiTorsion::write_data_section(int mth, FILE *fp, pack entire state of Fix into one write ------------------------------------------------------------------------- */ -void FixPiTorsion::write_restart(FILE *fp) +void FixAmoebaPiTorsion::write_restart(FILE *fp) { if (comm->me == 0) { int size = sizeof(bigint); @@ -934,7 +934,7 @@ void FixPiTorsion::write_restart(FILE *fp) use state info from restart file to restart the Fix ------------------------------------------------------------------------- */ -void FixPiTorsion::restart(char *buf) +void FixAmoebaPiTorsion::restart(char *buf) { npitorsions = *((bigint *) buf); } @@ -943,7 +943,7 @@ void FixPiTorsion::restart(char *buf) pack values in local atom-based arrays for restart file ------------------------------------------------------------------------- */ -int FixPiTorsion::pack_restart(int i, double *buf) +int FixAmoebaPiTorsion::pack_restart(int i, double *buf) { int n = 1; for (int m = 0; m < num_pitorsion[i]; m++) { @@ -964,7 +964,7 @@ int FixPiTorsion::pack_restart(int i, double *buf) unpack values from atom->extra array to restart the fix ------------------------------------------------------------------------- */ -void FixPiTorsion::unpack_restart(int nlocal, int nth) +void FixAmoebaPiTorsion::unpack_restart(int nlocal, int nth) { double **extra = atom->extra; @@ -992,7 +992,7 @@ void FixPiTorsion::unpack_restart(int nlocal, int nth) maxsize of any atom's restart data ------------------------------------------------------------------------- */ -int FixPiTorsion::maxsize_restart() +int FixAmoebaPiTorsion::maxsize_restart() { return 1 + PITORSIONMAX*6; } @@ -1001,7 +1001,7 @@ int FixPiTorsion::maxsize_restart() size of atom nlocal's restart data ------------------------------------------------------------------------- */ -int FixPiTorsion::size_restart(int nlocal) +int FixAmoebaPiTorsion::size_restart(int nlocal) { return 1 + num_pitorsion[nlocal]*7; } @@ -1010,7 +1010,7 @@ int FixPiTorsion::size_restart(int nlocal) allocate atom-based arrays ------------------------------------------------------------------------- */ -void FixPiTorsion::grow_arrays(int nmax) +void FixAmoebaPiTorsion::grow_arrays(int nmax) { num_pitorsion = memory->grow(num_pitorsion,nmax,"pitorsion:num_pitorsion"); pitorsion_type = memory->grow(pitorsion_type,nmax,PITORSIONMAX, @@ -1039,7 +1039,7 @@ void FixPiTorsion::grow_arrays(int nmax) copy values within local atom-based array ------------------------------------------------------------------------- */ -void FixPiTorsion::copy_arrays(int i, int j, int /*delflag*/) +void FixAmoebaPiTorsion::copy_arrays(int i, int j, int /*delflag*/) { num_pitorsion[j] = num_pitorsion[i]; @@ -1058,7 +1058,7 @@ void FixPiTorsion::copy_arrays(int i, int j, int /*delflag*/) initialize one atom's array values, called when atom is created ------------------------------------------------------------------------- */ -void FixPiTorsion::set_arrays(int i) +void FixAmoebaPiTorsion::set_arrays(int i) { num_pitorsion[i] = 0; } @@ -1067,7 +1067,7 @@ void FixPiTorsion::set_arrays(int i) pack values in local atom-based array for exchange with another proc ------------------------------------------------------------------------- */ -int FixPiTorsion::pack_exchange(int i, double *buf) +int FixAmoebaPiTorsion::pack_exchange(int i, double *buf) { int n = 0; buf[n++] = ubuf(num_pitorsion[i]).d; @@ -1087,7 +1087,7 @@ int FixPiTorsion::pack_exchange(int i, double *buf) unpack values in local atom-based array from exchange with another proc ------------------------------------------------------------------------- */ -int FixPiTorsion::unpack_exchange(int nlocal, double *buf) +int FixAmoebaPiTorsion::unpack_exchange(int nlocal, double *buf) { int n = 0; num_pitorsion[nlocal] = (int) ubuf(buf[n++]).i; @@ -1107,7 +1107,7 @@ int FixPiTorsion::unpack_exchange(int nlocal, double *buf) memory usage of local atom-based arrays ------------------------------------------------------------------------- */ -double FixPiTorsion::memory_usage() +double FixAmoebaPiTorsion::memory_usage() { int nmax = atom->nmax; double bytes = (double)nmax * sizeof(int); // num_pitorsion diff --git a/src/AMOEBA/fix_pitorsion.h b/src/AMOEBA/fix_amoeba_pitorsion.h similarity index 92% rename from src/AMOEBA/fix_pitorsion.h rename to src/AMOEBA/fix_amoeba_pitorsion.h index e335c6efa1..d1404c2580 100644 --- a/src/AMOEBA/fix_pitorsion.h +++ b/src/AMOEBA/fix_amoeba_pitorsion.h @@ -13,20 +13,20 @@ #ifdef FIX_CLASS // clang-format off -FixStyle(pitorsion,FixPiTorsion); +FixStyle(amoeba/pitorsion,FixAmoebaPiTorsion); // clang-format on #else -#ifndef LMP_FIX_PITORSION_H -#define LMP_FIX_PITORSION_H +#ifndef LMP_FIX_AMOEBA_PITORSION_H +#define LMP_FIX_AMOEBA_PITORSION_H #include "fix.h" namespace LAMMPS_NS { -class FixPiTorsion : public Fix { +class FixAmoebaPiTorsion : public Fix { public: - FixPiTorsion(class LAMMPS *, int, char **); - ~FixPiTorsion(); + FixAmoebaPiTorsion(class LAMMPS *, int, char **); + ~FixAmoebaPiTorsion(); int setmask(); void init(); void setup(int); diff --git a/src/modify.cpp b/src/modify.cpp index 07d5b8ee9b..3bb85d55f8 100644 --- a/src/modify.cpp +++ b/src/modify.cpp @@ -810,7 +810,8 @@ Fix *Modify::add_fix(int narg, char **arg, int trysuffix) const char *exceptions[] = {"GPU", "OMP", "INTEL", "property/atom", "cmap", "cmap3", "rx", - "deprecated", "STORE/KIM", "pitorsion", "bitorsion", nullptr}; + "deprecated", "STORE/KIM", "amoeba/pitorsion", "amoeba/bitorsion", + nullptr}; if (domain->box_exist == 0) { int m; From 0b2eda5f1d659b876fa2b30583c34433a7568395 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Thu, 24 Mar 2022 08:43:27 -0600 Subject: [PATCH 092/585] doc page edits --- doc/src/Howto_amoeba.rst | 70 +++++++++++++++++++++++++++------------- 1 file changed, 47 insertions(+), 23 deletions(-) diff --git a/doc/src/Howto_amoeba.rst b/doc/src/Howto_amoeba.rst index f60220f71b..9460d54200 100644 --- a/doc/src/Howto_amoeba.rst +++ b/doc/src/Howto_amoeba.rst @@ -3,8 +3,8 @@ AMOEBA and HIPPO force fields The AMOEBA and HIPPO polarizable force fields were developed by Jay Ponder's group at U Washington at St Louis. Their implementation in -LAMMPS was done using code provided by the Ponder group from their -`Tinker MD code `_ written in F90. +LAMMPS was done using F90 code provided by the Ponder group from their +`Tinker MD code `_ NOTE: what version of AMOEBA and HIPPO does LAMMPS implement? @@ -12,13 +12,13 @@ These force fields can be used when polarization effects are desired in simulations of water, organic molecules, and biomolecules including proteins, provided that parameterizations (force field files) are available for the systems you are interested in. Files in the LAMMPS -potentials with a "amoeba" or "hippo" suffix can be used. The Tinker -distribution and website may have other such files. +potentials directory with a "amoeba" or "hippo" suffix can be used. +The Tinker distribution and website may have other force field files. Note that currently, HIPPO can only be used for water systems, but HIPPO files for a variety of small organic and biomolecules are in -preparation by the Ponder group. They will be included in the LAMMPS -distribution when available. +preparation by the Ponder group. Those force field files will be +included in the LAMMPS distribution when available. The :doc:`pair_style amoeba ` doc page gives a brief description of the AMOEBA and HIPPO force fields. Further details for @@ -28,26 +28,50 @@ AMOEBA are in these papers: :ref:`(Ren) `, :ref:`(Shi) ---------- -To use the AMOEBA force field in LAMMPS you should use these commands -appropriately in your input script. The only change needed for a -HIPPO simulation is for the pair_style and pair_coeff commands. -See examples/amoeba for example input scripts. +To use the AMOEBA force field in LAMMPS you should use command like +these appropriately in your input script. The only change needed for +a HIPPO simulation is for the pair_style and pair_coeff commands. See +examples/amoeba for example input scripts for both AMOEBA and HIPPO. .. code-block:: LAMMPS - units real # required - atom_style hybrid full amoeba - bond_style amoeba - angle_style amoeba - dihedral_style amoeba - fix amtype all property/atom i_amtype ghost yes # fix ID matches read_data command - fix amoeba1 all property/atom & # fix ID (amoeba12) does not matter - i_amgroup i_ired i_xaxis i_yaxis i_zaxis d_pval ghost yes - fix amoeba2 all property/atom i_polaxe - read_data filename fix amtype NULL "Tinker Types" # fix ID matches fix command - pair_coeff * * ../potentials/protein.prm.amoeba ../potentials/protein.key.amoeba # for AMOEBA - pair_coeff * * ../potentials/water.prm.hippo ../potentials/water.key.hippo # for HIPPO - special_bonds lj/coul 0.5 0.5 0.5 one/five yes + units real # required + atom_style amoeba + bond_style class2 # CLASS2 package + angle_style amoeba + dihedral_style fourier # EXTRA-MOLECULE package + improper_style amoeba + # required per-atom data + fix amtype all property/atom i_amtype ghost yes + fix extra all property/atom & + i_amgroup i_ired i_xaxis i_yaxis i_zaxis d_pval ghost yes + fix polaxe all property/atom i_polaxe + + fix pit all amoeba/pitorsion # PiTorsion terms in FF + fix_modify pit energy yes + # Bitorsion terms in FF + fix bit all amoeba/bitorsion bitorsion.ubiquitin.data + fix_modify bit energy yes + + read_data data.ubiquitin fix amtype NULL "Tinker Types" & + fix pit "pitorsion types" "PiTorsion Coeffs" & + fix pit pitorsions PiTorsions & + fix bit bitorsions BiTorsions + + pair_style amoeba # AMOEBA FF + pair_coeff * * amoeba_ubiquitin.prm amoeba_ubiquitin.key + + pair_style hippo # HIPPO FF + pair_coeff * * hippo_water.prm hippo_water.key + + special_bonds lj/coul 0.5 0.5 0.5 one/five yes # 1-5 neighbors + + +NOTE: that some options not needed for simpler systems + +NOTE: tinker2lmp.py tool + +NOTE: are some commands not needed if system is simple and not ubi2 ? Both AMOEBA and HIPPO use amoeba for bond/angle/dihedral styles, assuming the molecular system has bonds, angles, or dihedrals. These From 365f5f7ad75e9baa682754006334ca141d899b43 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Mon, 28 Mar 2022 15:24:19 -0600 Subject: [PATCH 093/585] tweaks --- doc/src/Howto.rst | 1 + src/AMOEBA/fix_amoeba_bitorsion.cpp | 2 +- 2 files changed, 2 insertions(+), 1 deletion(-) diff --git a/doc/src/Howto.rst b/doc/src/Howto.rst index 8d8b7fb059..5b1ba55d7d 100644 --- a/doc/src/Howto.rst +++ b/doc/src/Howto.rst @@ -63,6 +63,7 @@ Force fields howto :maxdepth: 1 Howto_bioFF + Howto_amoeba Howto_tip3p Howto_tip4p Howto_spc diff --git a/src/AMOEBA/fix_amoeba_bitorsion.cpp b/src/AMOEBA/fix_amoeba_bitorsion.cpp index e9ff52a0b7..92cf10c5ce 100644 --- a/src/AMOEBA/fix_amoeba_bitorsion.cpp +++ b/src/AMOEBA/fix_amoeba_bitorsion.cpp @@ -374,7 +374,7 @@ void FixAmoebaBiTorsion::post_force(int vflag) // NOTE: extra until figure everything out int k,btype; - double radian; + double radian; // radians -> degrees = 57+ double engfraction; int nlist,list[6]; double v[6]; From 9b53bd0fbf0ba6bd7723b46a3ab4fb32e18bf2d4 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Tue, 29 Mar 2022 09:45:24 -0600 Subject: [PATCH 094/585] bitorsion fix --- src/AMOEBA/fix_amoeba_bitorsion.cpp | 462 +++++++++++++++++++++------- src/AMOEBA/fix_amoeba_bitorsion.h | 18 +- 2 files changed, 366 insertions(+), 114 deletions(-) diff --git a/src/AMOEBA/fix_amoeba_bitorsion.cpp b/src/AMOEBA/fix_amoeba_bitorsion.cpp index 92cf10c5ce..31dfd948c7 100644 --- a/src/AMOEBA/fix_amoeba_bitorsion.cpp +++ b/src/AMOEBA/fix_amoeba_bitorsion.cpp @@ -37,45 +37,6 @@ using namespace MathConst; #define LB_FACTOR 1.5 #define MAXLINE 1024 -// NOTE: extra until figure things out - -int tnx(int k) { - return 0; -} -int tny(int k) { - return 0; -} -int ttx(int i, int j) { - return 0; -} -int tty(int i, int j) { - return 0; -} -int ttxy(int i,int j) { - return 0; -} -double tbf(int i,int j) { - return 0.0; -} -double tbx(int i,int j) { - return 0.0; -} -double tby(int i,int j) { - return 0.0; -} -double tbxy(int i,int j) { - return 0.0; -} - -void chkttor(int ib, int ic, int id, int sign, double value1, double value2) { -} - -void bcuint1(double *ftt, double *ft1, double *ft2, double *ft12, - double x1l, double x1u, double y1l, double y1u, - double value1, double value2, - double e, double dedang1, double dedang2) { -} - /* ---------------------------------------------------------------------- */ FixAmoebaBiTorsion::FixAmoebaBiTorsion(LAMMPS *lmp, int narg, char **arg) : @@ -108,6 +69,7 @@ FixAmoebaBiTorsion::FixAmoebaBiTorsion(LAMMPS *lmp, int narg, char **arg) : // read and setup BiTorsion grid data read_grid_data(arg[3]); + create_splines(); // perform initial allocation of atom-based arrays @@ -164,9 +126,20 @@ FixAmoebaBiTorsion::~FixAmoebaBiTorsion() delete [] nxgrid; delete [] nygrid; - for (int itype = 1; itype <= ntypes; itype++) - memory->destroy(btgrid[itype]); - delete [] btgrid; + for (int itype = 1; itype <= nbitypes; itype++) { + memory->destroy(ttx[itype]); + memory->destroy(tty[itype]); + memory->destroy(tbf[itype]); + memory->destroy(tbx[itype]); + memory->destroy(tby[itype]); + memory->destroy(tbxy[itype]); + } + delete [] ttx; + delete [] tty; + delete [] tbf; + delete [] tbx; + delete [] tby; + delete [] tbxy; } /* ---------------------------------------------------------------------- */ @@ -324,8 +297,8 @@ void FixAmoebaBiTorsion::post_force(int vflag) { if (disable) return; - int ia,ib,ic,id,ie; - int nlo,nhi,nt; + int ia,ib,ic,id,ie,btype; + int nx,ny,nlo,nhi,nt; int xlo,ylo; int pos1,pos2; double e,fgrp,sign; @@ -371,15 +344,11 @@ void FixAmoebaBiTorsion::post_force(int vflag) double ftt[4],ft12[4]; double ft1[4],ft2[4]; - // NOTE: extra until figure everything out - - int k,btype; - double radian; // radians -> degrees = 57+ double engfraction; int nlist,list[6]; double v[6]; - // END of NOTE + double radian2degree = 180.0 / MY_PI; ebitorsion = 0.0; int eflag = eflag_caller; @@ -396,9 +365,6 @@ void FixAmoebaBiTorsion::post_force(int vflag) ic = bitorsion_list[n][2]; id = bitorsion_list[n][3]; ie = bitorsion_list[n][4]; - - // NOTE: is a btype ever used, i.e. as index into spline tables? - btype = bitorsion_list[n][5]; xia = x[ia][0]; @@ -451,84 +417,92 @@ void FixAmoebaBiTorsion::post_force(int vflag) rcb = sqrt(xcb*xcb + ycb*ycb + zcb*zcb); cosine1 = (xt*xu + yt*yu + zt*zu) / rtru; cosine1 = MIN(1.0,MAX(-1.0,cosine1)); - angle1 = radian * acos(cosine1); + angle1 = radian2degree * acos(cosine1); sign = xba*xu + yba*yu + zba*zu; - if (sign < 0.0) angle1 = -angle1; + if (sign < 0.0) angle1 = -angle1; value1 = angle1; rdc = sqrt(xdc*xdc + ydc*ydc + zdc*zdc); cosine2 = (xu*xv + yu*yv + zu*zv) / rurv; cosine2 = MIN(1.0,MAX(-1.0,cosine2)); - angle2 = radian * acos(cosine2); + angle2 = radian2degree * acos(cosine2); sign = xcb*xv + ycb*yv + zcb*zv; - if (sign < 0.0) angle2 = -angle2; + if (sign < 0.0) angle2 = -angle2; value2 = angle2; // check for inverted chirality at the central atom + // inputs = ib,ic,id + // outputs = sign,value1,value2 chkttor(ib,ic,id,sign,value1,value2); - // use bicubic interpolation to compute spline values - // NOTE: need to worry about C vs Fortran indexing - // both here and in the methods called - // NOTE: make sure pos1 and pos2 are ints + // 2 binary searches to find location of angles 1,2 in grid + // ttx,tty are 0-indexed here, 1-indexed in Tinker + // xlo,ylo = final location, each one less than in Tinker - nlo = 1; - nhi = tnx(k); + nx = nxgrid[btype]; + ny = nygrid[btype]; + + nlo = 0; + nhi = nx-1; while (nhi-nlo > 1) { nt = (nhi+nlo) / 2; - if (ttx(nt,k) > value1) nhi = nt; + if (ttx[btype][nt] > value1) nhi = nt; else nlo = nt; } - xlo = nlo; - nlo = 1; - nhi = tny(k); + + nlo = 0; + nhi = ny-1; while (nhi-nlo > 1) { nt = (nhi + nlo)/2; - if (tty(nt,k) > value2) nhi = nt; + if (tty[btype][nt] > value2) nhi = nt; else nlo = nt; } - ylo = nlo; - x1l = ttx(xlo,k); - x1u = ttx(xlo+1,k); - y1l = tty(ylo,k); - y1u = tty(ylo+1,k); - pos2 = ylo*tnx(k) + xlo; - pos1 = pos2 - tnx(k); - ftt[0] = tbf(pos1,k); - ftt[1] = tbf(pos1+1,k); - ftt[2] = tbf(pos2+1,k); - ftt[3] = tbf(pos2,k); + // fill ftt,ft1,ft2,ft12 vecs with spline coeffs near xlo,ylo grid pt + // ttx,tty,tbf,tbx,tby,tbxy are 0-indexed here, 1-indexed in Tinker + // xlo,ylo,pos1,pos2 are all one less than in Tinker - ft1[0] = tbx(pos1,k); - ft1[1] = tbx(pos1+1,k); - ft1[2] = tbx(pos2+1,k); - ft1[3] = tbx(pos2,k); + x1l = ttx[btype][xlo]; + x1u = ttx[btype][xlo+1]; + y1l = tty[btype][ylo]; + y1u = tty[btype][ylo+1]; - ft2[0] = tby(pos1,k); - ft2[1] = tby(pos1+1,k); - ft2[2] = tby(pos2+1,k); - ft2[3] = tby(pos2,k); + pos2 = ylo*nx + xlo; + pos1 = pos2 - nx; - ft12[0] = tbxy(pos1,k); - ft12[1] = tbxy(pos1+1,k); - ft12[2] = tbxy(pos2+1,k); - ft12[3] = tbxy(pos2,k); + ftt[0] = tbf[btype][pos1]; + ftt[1] = tbf[btype][pos1+1]; + ftt[2] = tbf[btype][pos2+1]; + ftt[3] = tbf[btype][pos2]; + + ft1[0] = tbx[btype][pos1]; + ft1[1] = tbx[btype][pos1+1]; + ft1[2] = tbx[btype][pos2+1]; + ft1[3] = tbx[btype][pos2]; + + ft2[0] = tby[btype][pos1]; + ft2[1] = tby[btype][pos1+1]; + ft2[2] = tby[btype][pos2+1]; + ft2[3] = tby[btype][pos2]; + + ft12[0] = tbxy[btype][pos1]; + ft12[1] = tbxy[btype][pos1+1]; + ft12[2] = tbxy[btype][pos2+1]; + ft12[3] = tbxy[btype][pos2]; + + // bicuint1() uses bicubic interpolation to compute interpolated values + // outputs = e,dedang1,dedang2 bcuint1(ftt,ft1,ft2,ft12,x1l,x1u,y1l,y1u,value1,value2, e,dedang1,dedang2); - // NOTE: remove ttorunit if 1.0 ? - // NOTE: what are radian units ? - // NOTE: value of sign is set twice above ?? - double ttorunit = 1.0; e *= ttorunit; - dedang1 = sign * ttorunit * radian * dedang1; - dedang2 = sign * ttorunit * radian * dedang2; + dedang1 = sign * ttorunit * radian2degree * dedang1; + dedang2 = sign * ttorunit * radian2degree * dedang2; // fraction of energy for each atom @@ -680,7 +654,7 @@ void FixAmoebaBiTorsion::min_post_force(int vflag) } /* ---------------------------------------------------------------------- - energy of BiTorision term + energy of BiTorsion term ------------------------------------------------------------------------- */ double FixAmoebaBiTorsion::compute_scalar() @@ -692,10 +666,24 @@ double FixAmoebaBiTorsion::compute_scalar() // ---------------------------------------------------------------------- // ---------------------------------------------------------------------- -// methods to read BiTorsion grid file, perform interpolation +// methods to read BiTorsion grid file, spline grids, perform interpolation // ---------------------------------------------------------------------- // ---------------------------------------------------------------------- +/* ---------------------------------------------------------------------- + read grid data from bitorsion_file produced by tinker2lmp.py + one entry for each biotorsion type + when complete: + nbitypes = # of bitorsion types + nxgrid,nygrid = x,y dimensions of grid for each type + ttx,tty = vectors of x,y angles for each type + length = nx or ny, 0-indexed + tbf = vector of 2d grid values for each type + length = nx*ny, 0-indexed, x varies fastest + ttx,tty,tbf are similar to Tinker data structs + here they are 0-indexed, in Tinker they are 1-indexed +------------------------------------------------------------------------- */ + void FixAmoebaBiTorsion::read_grid_data(char *bitorsion_file) { char line[MAXLINE]; @@ -714,22 +702,27 @@ void FixAmoebaBiTorsion::read_grid_data(char *bitorsion_file) if (eof == nullptr) error->one(FLERR,"Unexpected end of fix amoeba/bitorsion file"); - sscanf(line,"%d",&ntypes); + sscanf(line,"%d",&nbitypes); } - MPI_Bcast(&ntypes,1,MPI_INT,0,world); - if (ntypes == 0) error->all(FLERR,"Fix amoeba/bitorsion file has no types"); + MPI_Bcast(&nbitypes,1,MPI_INT,0,world); + if (nbitypes == 0) error->all(FLERR,"Fix amoeba/bitorsion file has no types"); - btgrid = new double***[ntypes+1]; - nxgrid = new int[ntypes+1]; - nygrid = new int[ntypes+1]; + // allocate data structs + // type index ranges from 1 to Nbitypes, so allocate one larger + + nxgrid = new int[nbitypes+1]; + nygrid = new int[nbitypes+1]; + ttx = new double*[nbitypes+1]; + tty = new double*[nbitypes+1]; + tbf = new double*[nbitypes+1]; // read one array for each BiTorsion type from file int tmp,nx,ny; double xgrid,ygrid,value; - for (int itype = 1; itype <= ntypes; itype++) { + for (int itype = 1; itype <= nbitypes; itype++) { if (me == 0) { eof = fgets(line,MAXLINE,fp); eof = fgets(line,MAXLINE,fp); @@ -743,7 +736,9 @@ void FixAmoebaBiTorsion::read_grid_data(char *bitorsion_file) nxgrid[itype] = nx; nygrid[itype] = ny; - memory->create(btgrid[itype],nx,ny,3,"bitorsion:btgrid"); + memory->create(ttx[itype],nx,"bitorsion:ttx"); + memory->create(tty[itype],ny,"bitorsion:tty"); + memory->create(tbf[itype],nx*ny,"bitorsion:tbf"); // NOTE: should read this chunk of lines with utils in single read @@ -754,19 +749,266 @@ void FixAmoebaBiTorsion::read_grid_data(char *bitorsion_file) if (eof == nullptr) error->one(FLERR,"Unexpected end of fix amoeba/bitorsion file"); sscanf(line,"%lg %lg %lg",&xgrid,&ygrid,&value); - btgrid[itype][ix][iy][0] = xgrid; - btgrid[itype][ix][iy][1] = ygrid; - btgrid[itype][ix][iy][2] = value; + if (iy == 0) ttx[itype][ix] = xgrid; + if (ix == 0) tty[itype][iy] = ygrid; + tbf[itype][iy*nx+ix] = value; } } } - MPI_Bcast(&btgrid[itype][0][0][0],nx*ny*3,MPI_DOUBLE,0,world); + MPI_Bcast(ttx[itype],nx,MPI_DOUBLE,0,world); + MPI_Bcast(tty[itype],ny,MPI_DOUBLE,0,world); + MPI_Bcast(tbf[itype],nx*ny,MPI_DOUBLE,0,world); } if (me == 0) fclose(fp); } +/* ---------------------------------------------------------------------- + create spline data structs for each bitorsion type + based on Tinker ktortor.f + when complete: + tbx,tby = spline coeffs + tbxy = vector of 2d grid values for each type, x varies fastest + tbx,tby,tbxy are similar to Tinker data structs + here they are 0-indexed, in Tinker they are 1-indexed +------------------------------------------------------------------------- */ + +void FixAmoebaBiTorsion::create_splines() +{ + int i,j,nx,ny; + + // allocate work vectors for cspline() and nspline() methods + // all are 0-indexed here and in Tinker + // tmp1,tmp2 = (x,y) inputs to spline methods + // bs = retained output from spline methods + // cs,ds,tmp3-7 = additional outputs from spline methods, not retained + // allocate to max length of any grid dimension for all types + + double *bs,*cs,*ds; + double *tmp1,*tmp2; + double *tmp3,*tmp4,*tmp5,*tmp6,*tmp7; + + int maxdim = 0; + for (int itype = 1; itype <= nbitypes; itype++) { + maxdim = MAX(maxdim,nxgrid[itype]); + maxdim = MAX(maxdim,nygrid[itype]); + } + + memory->create(bs,maxdim,"bitorsion:bs"); + memory->create(cs,maxdim,"bitorsion:cs"); + memory->create(ds,maxdim,"bitorsion:ds"); + memory->create(tmp1,maxdim,"bitorsion:tmp1"); + memory->create(tmp2,maxdim,"bitorsion:tmp2"); + memory->create(tmp3,maxdim,"bitorsion:tmp3"); + memory->create(tmp4,maxdim,"bitorsion:tmp4"); + memory->create(tmp5,maxdim,"bitorsion:tmp5"); + memory->create(tmp6,maxdim,"bitorsion:tmp6"); + memory->create(tmp7,maxdim,"bitorsion:tmp7"); + + // allocate data structs + // type index ranges from 1 to Nbitypes, so allocate one larger + + tbx = new double*[nbitypes+1]; + tby = new double*[nbitypes+1]; + tbxy = new double*[nbitypes+1]; + + for (int itype = 1; itype <= nbitypes; itype++) { + + nx = nxgrid[itype]; + ny = nygrid[itype]; + + // cyclic = 1 if angle range is -180.0 to 180.0 in both dims + // error if cyclic and x,y pairs of edges of 2d array values do not match + // equality comparisons are within eps + + int cyclic = 1; + double eps = 1.0e-6; + + if (fabs(fabs(ttx[itype][0]-ttx[itype][nx-1]) - 360.0) > eps) cyclic = 0; + if (fabs(fabs(tty[itype][0]-tty[itype][ny-1]) - 360.0) > eps) cyclic = 0; + + if (cyclic) { + // do error check on matching edge values + } + + // allocate nx*ny vectors for itype + + memory->create(tbx[itype],nx*ny,"bitorsion:tbx"); + memory->create(tby[itype],nx*ny,"bitorsion:tby"); + memory->create(tbxy[itype],nx*ny,"bitorsion:tbxy"); + + // spline fit of derivatives about 1st torsion + + for (int i = 0; i < nx; i++) + tmp1[i] = ttx[itype][i]; + + for (int j = 0; j < ny; j++) { + for (int i = 0; i < nx; i++) + tmp2[i] = tbf[itype][j*nx+i]; + + if (cyclic) + cspline(nx-1,tmp1,tmp2,bs,cs,ds,tmp3,tmp4,tmp5,tmp6,tmp7); + else + nspline(nx-1,tmp1,tmp2,bs,cs,tmp3,tmp4,tmp5,tmp6,tmp7); + + for (int i = 0; i < nx; i++) + tbx[itype][j*nx+i] = bs[i]; + } + + // spline fit of derivatives about 2nd torsion + + for (int j = 0; j < ny; j++) + tmp1[j] = ttx[itype][j]; + + for (int i = 0; i < nx; i++) { + for (int j = 0; j < ny; j++) + tmp2[j] = tbf[itype][j*nx+i]; + + if (cyclic) + cspline(ny-1,tmp1,tmp2,bs,cs,ds,tmp3,tmp4,tmp5,tmp6,tmp7); + else + nspline(ny-1,tmp1,tmp2,bs,cs,tmp3,tmp4,tmp5,tmp6,tmp7); + + for (int j = 0; i < ny; j++) + tby[itype][j*nx+i] = bs[j]; + } + + // spline fit of cross derivatives about both torsions + + for (int j = 0; j < ny; j++) + tmp1[j] = ttx[itype][j]; + + for (int i = 0; i < nx; i++) { + for (int j = 0; j < ny; j++) + tmp2[j] = tbx[itype][j*nx+i]; + + if (cyclic) + cspline(ny-1,tmp1,tmp2,bs,cs,ds,tmp3,tmp4,tmp5,tmp6,tmp7); + else + nspline(ny-1,tmp1,tmp2,bs,cs,tmp3,tmp4,tmp5,tmp6,tmp7); + + for (int j = 0; i < ny; j++) + tbxy[itype][j*nx+i] = bs[j]; + } + } + + // free work vectors local to this method + + memory->destroy(bs); + memory->destroy(cs); + memory->destroy(ds); + memory->destroy(tmp1); + memory->destroy(tmp2); + memory->destroy(tmp3); + memory->destroy(tmp4); + memory->destroy(tmp5); + memory->destroy(tmp6); + memory->destroy(tmp7); +} + +/* ---------------------------------------------------------------------- +------------------------------------------------------------------------- */ + +void FixAmoebaBiTorsion::cspline(int n, double *xn, double *fn, + double *b, double *c, double *d, + double *h, double *du, double *dm, + double *rc, double *rs) +{ +} + +/* ---------------------------------------------------------------------- + Tinker method + nspline() computes coefficients for an nonperiodic cubic spline + with natural boundary conditions where the first and last second + derivatives are already known + all vectors are of length n+1 and are indexed from 0 to n inclusive + n,x0,y0 are inputs + rest of args are outputs +------------------------------------------------------------------------- */ + +void FixAmoebaBiTorsion::nspline(int n, double *x0, double *y0, + double *s1, double *s2, + double *h, double *g, double *dy, + double *dla, double *dmu) +{ + int i; + double t; + + // set first and last second deriviatives to zero + + double y21 = 0.0; + double y2n = 0.0; + + // find the intervals to be used + + for (i = 0; i <= n-1; i++) { + h[i] = x0[i+1] - x0[i]; + dy[i] = (y0[i+1]-y0[i]) / h[i]; + } + + // calculate the spline coeffcients + + for (i = 1; i <= n-1; i++) { + dla[i] = h[i] / (h[i]+h[i-1]); + dmu[i] = 1.0 - dla[i]; + g[i] = 3.0 * (dla[i]*dy[i-1]+dmu[i]*dy[i]); + } + + // set the initial value via natural boundary condition + + dla[n] = 1.0; + dla[0] = 0.0; + dmu[n] = 0.0; + dmu[0] = 1.0; + g[0] = 3.0*dy[0] - 0.5*h[0]*y21; + g[n] = 3.0*dy[n-1] + 0.5*h[n-1]*y2n; + + // solve the triagonal system of linear equations + + dmu[0] = 0.5 * dmu[0]; + g[0] = 0.5 * g[0]; + + for (i = 1; i <= n; i++) { + t = 2.0 - dmu[i-1]*dla[i]; + dmu[i] = dmu[i] / t; + g[i] = (g[i]-g[i-1]*dla[i]) / t; + } + for (i = n-1; i >= 0; i--) + g[i] = g[i] - dmu[i]*g[i+1]; + + // get the first derivative at each grid point + + for (i = 0; i <= n; i++) + s1[i] = g[i]; + + // get the second derivative at each grid point + + s2[0] = y21; + s2[n] = y2n; + for (i = 1; i <= n-1; i++) + s2[i] = 6.0*(y0[i+1]-y0[i])/(h[i]*h[i]) - 4.0*s1[i]/h[i] - 2.0*s1[i+1]/h[i]; +} + +/* ---------------------------------------------------------------------- +------------------------------------------------------------------------- */ + +void FixAmoebaBiTorsion::chkttor(int ib, int ic, int id, + double &sign, double &value1, double &value2) +{ +} + +/* ---------------------------------------------------------------------- +------------------------------------------------------------------------- */ + +void FixAmoebaBiTorsion::bcuint1(double *ftt, double *ft1, + double *ft2, double *ft12, + double x1l, double x1u, double y1l, double y1u, + double value1, double value2, + double &e, double &dedang1, double &dedang2) +{ +} + // ---------------------------------------------------------------------- // ---------------------------------------------------------------------- // methods to read and write data file diff --git a/src/AMOEBA/fix_amoeba_bitorsion.h b/src/AMOEBA/fix_amoeba_bitorsion.h index 49af5cc95d..065529cd3f 100644 --- a/src/AMOEBA/fix_amoeba_bitorsion.h +++ b/src/AMOEBA/fix_amoeba_bitorsion.h @@ -90,15 +90,25 @@ class FixAmoebaBiTorsion : public Fix { int max_bitorsion_list; int **bitorsion_list; - // BiTorsion grid data + // BiTorsion grid and spline data - int ntypes; + int nbitypes; int *nxgrid,*nygrid; - double ****btgrid; + double **ttx,**tty,**tbf; + double **tbx,**tby,**tbxy; - // read BiTorsion grid data + // local methods void read_grid_data(char *); + void create_splines(); + void cspline(int, double *, double *, double *, double *, double *, + double *, double *, double *, double *, double *); + void nspline(int, double *, double *, double *, double *, + double *, double *, double *, double *, double *); + void chkttor(int, int, int, double &, double &, double &); + void bcuint1(double *, double *, double *, double *, + double, double, double, double, double, double, + double &, double &, double &); }; } // namespace LAMMPS_NS From 841931b92b6bbdb3e61b4df53348fd8c673327bf Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Tue, 29 Mar 2022 14:09:17 -0600 Subject: [PATCH 095/585] fleshing out bitorsion fix --- examples/amoeba/in.ubiquitin | 2 +- src/AMOEBA/fix_amoeba_bitorsion.cpp | 341 ++++++++++++++++++++++++++-- src/AMOEBA/fix_amoeba_bitorsion.h | 11 +- 3 files changed, 327 insertions(+), 27 deletions(-) diff --git a/examples/amoeba/in.ubiquitin b/examples/amoeba/in.ubiquitin index 4d5e341bcd..d297cf01cc 100644 --- a/examples/amoeba/in.ubiquitin +++ b/examples/amoeba/in.ubiquitin @@ -29,7 +29,7 @@ read_data data.ubiquitin fix amtype NULL "Tinker Types" & fix pit pitorsions PiTorsions & fix bit bitorsions BiTorsions -pair_style amoeba exclude bitorsion +pair_style amoeba pair_coeff * * amoeba_ubiquitin.prm amoeba_ubiquitin.key special_bonds lj/coul 0.5 0.5 0.5 one/five yes diff --git a/src/AMOEBA/fix_amoeba_bitorsion.cpp b/src/AMOEBA/fix_amoeba_bitorsion.cpp index 31dfd948c7..7029d239bd 100644 --- a/src/AMOEBA/fix_amoeba_bitorsion.cpp +++ b/src/AMOEBA/fix_amoeba_bitorsion.cpp @@ -37,6 +37,27 @@ using namespace MathConst; #define LB_FACTOR 1.5 #define MAXLINE 1024 +// spline weighting factors + +static constexpr double WT[16][16] = { +{ 1.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0}, +{ 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 1.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0}, +{-3.0, 0.0, 0.0, 3.0, 0.0, 0.0, 0.0, 0.0,-2.0, 0.0, 0.0,-1.0, 0.0, 0.0, 0.0, 0.0}, +{ 2.0, 0.0, 0.0,-2.0, 0.0, 0.0, 0.0, 0.0, 1.0, 0.0, 0.0, 1.0, 0.0, 0.0, 0.0, 0.0}, +{ 0.0, 0.0, 0.0, 0.0, 1.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0}, +{ 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 1.0, 0.0, 0.0, 0.0}, +{ 0.0, 0.0, 0.0, 0.0,-3.0, 0.0, 0.0, 3.0, 0.0, 0.0, 0.0, 0.0,-2.0, 0.0, 0.0,-1.0}, +{ 0.0, 0.0, 0.0, 0.0, 2.0, 0.0, 0.0,-2.0, 0.0, 0.0, 0.0, 0.0, 1.0, 0.0, 0.0, 1.0}, +{-3.0, 3.0, 0.0, 0.0,-2.0,-1.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0}, +{ 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0,-3.0, 3.0, 0.0, 0.0,-2.0,-1.0, 0.0, 0.0}, +{ 9.0,-9.0, 9.0,-9.0, 6.0, 3.0,-3.0,-6.0, 6.0,-6.0,-3.0, 3.0, 4.0, 2.0, 1.0, 2.0}, +{-6.0, 6.0,-6.0, 6.0,-4.0,-2.0, 2.0, 4.0,-3.0, 3.0, 3.0,-3.0,-2.0,-1.0,-1.0,-2.0}, +{ 2.0,-2.0, 0.0, 0.0, 1.0, 1.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0}, +{ 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 2.0,-2.0, 0.0, 0.0, 1.0, 1.0, 0.0, 0.0}, +{-6.0, 6.0,-6.0, 6.0,-3.0,-3.0, 3.0, 3.0,-4.0, 4.0, 2.0,-2.0,-2.0,-2.0,-1.0,-1.0}, +{ 4.0,-4.0, 4.0,-4.0, 2.0, 2.0,-2.0,-2.0, 2.0,-2.0,-2.0, 2.0, 1.0, 1.0, 1.0, 1.0} +}; + /* ---------------------------------------------------------------------- */ FixAmoebaBiTorsion::FixAmoebaBiTorsion(LAMMPS *lmp, int narg, char **arg) : @@ -499,10 +520,12 @@ void FixAmoebaBiTorsion::post_force(int vflag) bcuint1(ftt,ft1,ft2,ft12,x1l,x1u,y1l,y1u,value1,value2, e,dedang1,dedang2); - double ttorunit = 1.0; - e *= ttorunit; - dedang1 = sign * ttorunit * radian2degree * dedang1; - dedang2 = sign * ttorunit * radian2degree * dedang2; + printf("BiTorsion %d %d %d %d %d: angle12 %g %g: eng %g\n", + atom->tag[ia],atom->tag[ib],atom->tag[ic],atom->tag[id],atom->tag[ie], + angle1,angle2,e); + + dedang1 = sign * radian2degree * dedang1; + dedang2 = sign * radian2degree * dedang2; // fraction of energy for each atom @@ -870,7 +893,7 @@ void FixAmoebaBiTorsion::create_splines() else nspline(ny-1,tmp1,tmp2,bs,cs,tmp3,tmp4,tmp5,tmp6,tmp7); - for (int j = 0; i < ny; j++) + for (int j = 0; j < ny; j++) tby[itype][j*nx+i] = bs[j]; } @@ -888,7 +911,7 @@ void FixAmoebaBiTorsion::create_splines() else nspline(ny-1,tmp1,tmp2,bs,cs,tmp3,tmp4,tmp5,tmp6,tmp7); - for (int j = 0; i < ny; j++) + for (int j = 0; j < ny; j++) tbxy[itype][j*nx+i] = bs[j]; } } @@ -908,18 +931,8 @@ void FixAmoebaBiTorsion::create_splines() } /* ---------------------------------------------------------------------- -------------------------------------------------------------------------- */ - -void FixAmoebaBiTorsion::cspline(int n, double *xn, double *fn, - double *b, double *c, double *d, - double *h, double *du, double *dm, - double *rc, double *rs) -{ -} - -/* ---------------------------------------------------------------------- - Tinker method - nspline() computes coefficients for an nonperiodic cubic spline + Tinker method nspline() + computes coefficients for an nonperiodic cubic spline with natural boundary conditions where the first and last second derivatives are already known all vectors are of length n+1 and are indexed from 0 to n inclusive @@ -990,6 +1003,220 @@ void FixAmoebaBiTorsion::nspline(int n, double *x0, double *y0, s2[i] = 6.0*(y0[i+1]-y0[i])/(h[i]*h[i]) - 4.0*s1[i]/h[i] - 2.0*s1[i+1]/h[i]; } +/* ---------------------------------------------------------------------- + Tinker method cspline() + computes coefficients for an periodic interpolating cubic spline + all vectors are of length n+1 and are indexed from 0 to n inclusive + n,xn,fn are inputs + rest of args are outputs +------------------------------------------------------------------------- */ + +void FixAmoebaBiTorsion::cspline(int n, double *xn, double *fn, + double *b, double *c, double *d, + double *h, double *du, double *dm, + double *rc, double *rs) +{ + int i; + double temp1,temp2; + + double average = 0.5 * (fn[0] + fn[n]); + fn[0] = average; + fn[n] = average; + + // get auxiliary variables and matrix elements on first call + + for (i = 0; i < n; i++) + h[i] = xn[i+1] - xn[i]; + h[n] = h[0]; + + for (i = 1; i < n; i++) + du[i] = h[i]; + du[n] = h[0]; + + for (i = 1; i <= n; i++) + dm[i] = 2.0 * (h[i-1]+h[i]); + + // compute the right hand side + + temp1 = (fn[1]-fn[0]) / h[0]; + for (i = 1; i < n; i++) { + temp2 = (fn[i+1]-fn[i]) / h[i]; + rs[i] = 3.0 * (temp2-temp1); + temp1 = temp2; + } + rs[n] = 3.0 * ((fn[1]-fn[0])/h[0]-temp1); + + // solve the linear system with factorization + + int iflag; + cytsy(n,dm,du,rc,rs,c,iflag); + if (iflag != 1) return; + + // compute remaining spline coefficients + + c[0] = c[n]; + for (i = 0; i < n; i++) { + b[i] = (fn[i+1]-fn[i])/h[i] - h[i]/3.0*(c[i+1]+2.0*c[i]); + d[i] = (c[i+1]-c[i]) / (3.0*h[i]); + } + b[n] = (fn[1]-fn[n])/h[n] - h[n]/3.0*(c[1]+2.0*c[n]); +} + +/* ---------------------------------------------------------------------- + Tinker method cytsy() + solve cyclic tridiagonal system + all vectors are of length n+1 and are indexed from 0 to n inclusive + n,dm,du are inputs + du,cr,rs,x,iflag are outputs +------------------------------------------------------------------------- */ + +void FixAmoebaBiTorsion::cytsy(int n, double *dm, double *du, + double *cr, double *rs, double *x, int &iflag) +{ + iflag = -2; + if (n < 3) return; + cytsyp(n,dm,du,cr,iflag); + + // update and back substitute as necessary + + if (iflag == 1) cytsys(n,dm,du,cr,rs,x); +} + +/* ---------------------------------------------------------------------- + Tinker method ctsys() + tridiagonal Cholesky factorization + all vectors are of length n+1 and are indexed from 0 to n inclusive + n,dm,du are inputs + du,cr,iflag are outputs +------------------------------------------------------------------------- */ + +void FixAmoebaBiTorsion::cytsyp(int n, double *dm, double *du, + double *cr, int &iflag) +{ + int i; + double temp1,temp2; + + // set error bound and test for condition n greater than 2 + + double eps = 1.0e-8; + + iflag = -2; + if (n < 3) return; + + // checking to see if matrix is positive definite + + double row = fabs(dm[1]) + fabs(du[1]) + fabs(du[n]); + + if (row == 0.0) { + iflag = 0; + return; + } + + double d = 1.0 / row; + + if (dm[1] < 0.0) { + iflag = -1; + return; + } else if (fabs(dm[1])*d <= eps) { + iflag = 0; + return; + } + + // factoring a while checking for a positive definite and + // strong nonsingular matrix a + + temp1 = du[1]; + du[1] = du[1] / dm[1]; + cr[1] = du[n] / dm[1]; + + for (i = 2; i < n; i++) { + row = fabs(dm[i]) + fabs(du[i]) + fabs(temp1); + if (row == 0.0) { + iflag = 0; + return; + } + d = 1.0 / row; + dm[i] = dm[i] - temp1*du[i-1]; + if (dm[i] < 0.0) { + iflag = -1; + return; + } else if (abs(dm[i])*d <= eps) { + iflag = 0; + return; + } + if (i < n-1) { + cr[i] = -temp1 * cr[i-1] / dm[i]; + temp1 = du[i]; + du[i] = du[i] / dm[i]; + } else { + temp2 = du[i]; + du[i] = (du[i] - temp1*cr[i-1]) / dm[i]; + } + } + + row = fabs(du[n]) + fabs(dm[n]) + fabs(temp2); + if (row == 0.0) { + iflag = 0; + return; + } + + d = 1.0 / row; + dm[n] = dm[n] - dm[n-1]*du[n-1]*du[n-1]; + temp1 = 0.0; + + for (i = 1; i < n-1; i++) + temp1 += dm[i]*cr[i]*cr[i]; + + dm[n] = dm[n] - temp1; + + if (dm[n] < 0.0) { + iflag = -1; + return; + } else if (fabs(dm[n])*d <= eps) { + iflag = 0; + return; + } + + iflag = 1; +} + +/* ---------------------------------------------------------------------- + Tinker method cytsys() + tridiagonal solution from factors + all vectors are of length n+1 and are indexed from 0 to n inclusive + n,dm,du,cr are inputs + rs,x are outputs +------------------------------------------------------------------------- */ + +void FixAmoebaBiTorsion::cytsys(int n, double *dm, double *du, + double *cr, double *rs, double *x) +{ + int i; + + // updating phase + + double temp = rs[1]; + rs[1] = temp / dm[1]; + double sum = cr[1] * temp; + + for (i = 2; i < n; i++) { + temp = rs[i] - du[i-1]*temp; + rs[i] = temp / dm[i]; + if (i != n-1) sum += cr[i]*temp; + } + + temp = rs[n] - du[n-1]*temp; + temp = temp - sum; + rs[n] = temp / dm[n]; + + // back substitution phase + + x[n] = rs[n]; + x[n-1] = rs[n-1] - du[n-1]*x[n]; + for (i = n-2; i > 0; i--) + x[i] = rs[i] - du[i]*x[i+1] - cr[i]*x[n]; +} + /* ---------------------------------------------------------------------- ------------------------------------------------------------------------- */ @@ -999,14 +1226,80 @@ void FixAmoebaBiTorsion::chkttor(int ib, int ic, int id, } /* ---------------------------------------------------------------------- + perform bicubic spline interpolation + based on Tinker bcuint1.f + input = all args except last 3 + output = ansy,ansy1,ansy2 ------------------------------------------------------------------------- */ -void FixAmoebaBiTorsion::bcuint1(double *ftt, double *ft1, - double *ft2, double *ft12, - double x1l, double x1u, double y1l, double y1u, - double value1, double value2, - double &e, double &dedang1, double &dedang2) +void FixAmoebaBiTorsion::bcuint1(double *y, double *y1, + double *y2, double *y12, + double x1l, double x1u, double x2l, double x2u, + double x1, double x2, + double &ansy, double &ansy1, double &ansy2) { + double c[4][4]; + + // get coefficients, then perform bicubic interpolation + + bcucof(y,y1,y2,y12,x1u-x1l,x2u-x2l,c); + + double t = (x1-x1l) / (x1u-x1l); + double u = (x2-x2l) / (x2u-x2l); + + ansy = ansy1 = ansy2 = 0.0; + + for (int i = 4; i >= 1; i--) { + ansy = t*ansy + ((c[i][3]*u+c[i][2])*u+c[i][1])*u + c[i][0]; + ansy1 = u*ansy1 + (3.0*c[3][i]*t+2.0*c[2][i])*t + c[1][i]; + ansy2 = t*ansy2 + (3.0*c[i][3]*u+2.0*c[i][2])*u + c[i][1]; + } + + ansy1 /= x1u-x1l; + ansy2 /= x2u-x2l; +} + +/* ---------------------------------------------------------------------- + compute bicubic spline coeffs + based on Tinker bcucof.f + input = all args except c + output = c +------------------------------------------------------------------------- */ + +void FixAmoebaBiTorsion::bcucof(double *y, double *y1, double *y2, double *y12, + double d1, double d2, double c[4][4]) +{ + int i,j,k; + double xx; + double x[16],cl[16]; + + // pack a temporary vector of corner values + + double d1d2 = d1 * d2; + for (i = 0; i < 4; i++) { + x[i] = y[i]; + x[i+4] = y1[i] * d1; + x[i+8] = y2[i] * d2; + x[i+12] = y12[i] * d1d2; + } + + // matrix multiply by the stored weight table + + for (i = 0; i < 16; i++) { + xx = 0.0; + for (k = 0; k < 16; k++) + xx += WT[i][k]*x[k]; + cl[i] = xx; + } + + // unpack the result into the coefficient table + + j = 0; + for (i = 0; i < 4; i++) { + for (k = 0; k < 4; k++) { + c[i][k] = cl[j++]; + } + } } // ---------------------------------------------------------------------- @@ -1416,7 +1709,7 @@ double FixAmoebaBiTorsion::memory_usage() { int nmax = atom->nmax; double bytes = (double)nmax * sizeof(int); // num_bitorsion - bytes += (double)nmax*BITORSIONMAX * sizeof(int); // bitorsion_type + bytes += (double)nmax*BITORSIONMAX * sizeof(int); // bitorsion_type bytes += (double)5*nmax*BITORSIONMAX * sizeof(int); // bitorsion_atom 12345 bytes += (double)6*max_bitorsion_list * sizeof(int); // bitorsion_list return bytes; diff --git a/src/AMOEBA/fix_amoeba_bitorsion.h b/src/AMOEBA/fix_amoeba_bitorsion.h index 065529cd3f..b0b85a300d 100644 --- a/src/AMOEBA/fix_amoeba_bitorsion.h +++ b/src/AMOEBA/fix_amoeba_bitorsion.h @@ -101,15 +101,22 @@ class FixAmoebaBiTorsion : public Fix { void read_grid_data(char *); void create_splines(); - void cspline(int, double *, double *, double *, double *, double *, - double *, double *, double *, double *, double *); void nspline(int, double *, double *, double *, double *, double *, double *, double *, double *, double *); + void cspline(int, double *, double *, double *, double *, double *, + double *, double *, double *, double *, double *); + void cytsy(int, double *, double *, double *, double *, double *, int &); + void cytsyp(int, double *, double *, double *, int &); + void cytsys(int, double *, double *, double *, double *, double *); + void chkttor(int, int, int, double &, double &, double &); void bcuint1(double *, double *, double *, double *, double, double, double, double, double, double, double &, double &, double &); + void bcucof(double *, double *, double *, double *, double, double, + double [][4]); }; + } // namespace LAMMPS_NS #endif From 9162d8842d7e7b48a8bd32df2d6f0efca1b1d456 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Wed, 30 Mar 2022 11:20:33 -0600 Subject: [PATCH 096/585] debugging --- src/AMOEBA/fix_amoeba_bitorsion.cpp | 39 +++++++++++++++++++++++++---- 1 file changed, 34 insertions(+), 5 deletions(-) diff --git a/src/AMOEBA/fix_amoeba_bitorsion.cpp b/src/AMOEBA/fix_amoeba_bitorsion.cpp index 7029d239bd..feb6a273a3 100644 --- a/src/AMOEBA/fix_amoeba_bitorsion.cpp +++ b/src/AMOEBA/fix_amoeba_bitorsion.cpp @@ -466,21 +466,32 @@ void FixAmoebaBiTorsion::post_force(int vflag) nlo = 0; nhi = nx-1; + + if (n == 0) printf("Starting Ang1 search: nlo %d nhi %d\n",nlo,nhi); while (nhi-nlo > 1) { nt = (nhi+nlo) / 2; if (ttx[btype][nt] > value1) nhi = nt; else nlo = nt; + if (n == 0) + printf(" iteration on Ang1: nlo %d nhi %d ttx[nt] %g val1 %g\n", + nlo,nhi,ttx[btype][nt],value1); } xlo = nlo; + if (n == 0) printf("End of Ang1 search: xlo %d\n",xlo); nlo = 0; nhi = ny-1; + if (n == 0) printf("Starting Ang2 search: nlo %d nhi %d\n",nlo,nhi); while (nhi-nlo > 1) { nt = (nhi + nlo)/2; if (tty[btype][nt] > value2) nhi = nt; else nlo = nt; + if (n == 0) + printf(" iteration on Ang2: nlo %d nhi %d tty[nt] %g val2 %g\n", + nlo,nhi,tty[btype][nt],value2); } ylo = nlo; + if (n == 0) printf("End of Ang2 search: xlo %d\n",ylo); // fill ftt,ft1,ft2,ft12 vecs with spline coeffs near xlo,ylo grid pt // ttx,tty,tbf,tbx,tby,tbxy are 0-indexed here, 1-indexed in Tinker @@ -491,7 +502,7 @@ void FixAmoebaBiTorsion::post_force(int vflag) y1l = tty[btype][ylo]; y1u = tty[btype][ylo+1]; - pos2 = ylo*nx + xlo; + pos2 = (ylo+1)*nx + xlo; pos1 = pos2 - nx; ftt[0] = tbf[btype][pos1]; @@ -520,13 +531,31 @@ void FixAmoebaBiTorsion::post_force(int vflag) bcuint1(ftt,ft1,ft2,ft12,x1l,x1u,y1l,y1u,value1,value2, e,dedang1,dedang2); - printf("BiTorsion %d %d %d %d %d: angle12 %g %g: eng %g\n", - atom->tag[ia],atom->tag[ib],atom->tag[ic],atom->tag[id],atom->tag[ie], - angle1,angle2,e); - dedang1 = sign * radian2degree * dedang1; dedang2 = sign * radian2degree * dedang2; + // DEBUG + + if (n == 0) { + printf("BiTorsion: %d %d %d %d %d: type %d\n", + atom->tag[ia], + atom->tag[ib], + atom->tag[ic], + atom->tag[id], + atom->tag[ie], + btype); + + printf(" nx/ny %d %d\n",nx,ny); + printf(" xlo/ylo %d %d pos1/2 %d %d\n",xlo+1,ylo+1,pos1+1,pos2+1); + printf(" x1l/x1u %g %g y1l/y1u %g %g\n",x1l,x1u,y1l,y1u); + printf(" ftt 0123: %g %g %g %g\n",ftt[0],ftt[1],ftt[2],ftt[3]); + printf(" ft1 0123: %g %g %g %g\n",ft1[0],ft1[1],ft1[2],ft1[3]); + printf(" ft2 0123: %g %g %g %g\n",ft2[0],ft2[1],ft2[2],ft2[3]); + printf(" ft12 0123: %g %g %g %g\n",ft12[0],ft12[1],ft12[2],ft12[3]); + printf(" value1/2: %g %g eng %g\n",value1,value2,e); + printf(" dedang1/2: %g %g\n",dedang1,dedang2); + } + // fraction of energy for each atom engfraction = e * onefifth; From d28b9818bbfb8da2c485f03fdabcaf266bfdc261 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Wed, 30 Mar 2022 13:02:15 -0600 Subject: [PATCH 097/585] working changes to fix bitorsion --- src/AMOEBA/fix_amoeba_bitorsion.cpp | 42 +++++++++-------------------- 1 file changed, 12 insertions(+), 30 deletions(-) diff --git a/src/AMOEBA/fix_amoeba_bitorsion.cpp b/src/AMOEBA/fix_amoeba_bitorsion.cpp index feb6a273a3..7a8c5253b6 100644 --- a/src/AMOEBA/fix_amoeba_bitorsion.cpp +++ b/src/AMOEBA/fix_amoeba_bitorsion.cpp @@ -379,6 +379,8 @@ void FixAmoebaBiTorsion::post_force(int vflag) double **f = atom->f; int nlocal = atom->nlocal; + //printf("Nbitorsions %d\n",nbitorsion_list); + for (int n = 0; n < nbitorsion_list; n++) { ia = bitorsion_list[n][0]; @@ -467,31 +469,21 @@ void FixAmoebaBiTorsion::post_force(int vflag) nlo = 0; nhi = nx-1; - if (n == 0) printf("Starting Ang1 search: nlo %d nhi %d\n",nlo,nhi); while (nhi-nlo > 1) { nt = (nhi+nlo) / 2; if (ttx[btype][nt] > value1) nhi = nt; else nlo = nt; - if (n == 0) - printf(" iteration on Ang1: nlo %d nhi %d ttx[nt] %g val1 %g\n", - nlo,nhi,ttx[btype][nt],value1); } xlo = nlo; - if (n == 0) printf("End of Ang1 search: xlo %d\n",xlo); nlo = 0; nhi = ny-1; - if (n == 0) printf("Starting Ang2 search: nlo %d nhi %d\n",nlo,nhi); while (nhi-nlo > 1) { nt = (nhi + nlo)/2; if (tty[btype][nt] > value2) nhi = nt; else nlo = nt; - if (n == 0) - printf(" iteration on Ang2: nlo %d nhi %d tty[nt] %g val2 %g\n", - nlo,nhi,tty[btype][nt],value2); } ylo = nlo; - if (n == 0) printf("End of Ang2 search: xlo %d\n",ylo); // fill ftt,ft1,ft2,ft12 vecs with spline coeffs near xlo,ylo grid pt // ttx,tty,tbf,tbx,tby,tbxy are 0-indexed here, 1-indexed in Tinker @@ -536,25 +528,15 @@ void FixAmoebaBiTorsion::post_force(int vflag) // DEBUG - if (n == 0) { - printf("BiTorsion: %d %d %d %d %d: type %d\n", - atom->tag[ia], - atom->tag[ib], - atom->tag[ic], - atom->tag[id], - atom->tag[ie], - btype); - - printf(" nx/ny %d %d\n",nx,ny); - printf(" xlo/ylo %d %d pos1/2 %d %d\n",xlo+1,ylo+1,pos1+1,pos2+1); - printf(" x1l/x1u %g %g y1l/y1u %g %g\n",x1l,x1u,y1l,y1u); - printf(" ftt 0123: %g %g %g %g\n",ftt[0],ftt[1],ftt[2],ftt[3]); - printf(" ft1 0123: %g %g %g %g\n",ft1[0],ft1[1],ft1[2],ft1[3]); - printf(" ft2 0123: %g %g %g %g\n",ft2[0],ft2[1],ft2[2],ft2[3]); - printf(" ft12 0123: %g %g %g %g\n",ft12[0],ft12[1],ft12[2],ft12[3]); - printf(" value1/2: %g %g eng %g\n",value1,value2,e); - printf(" dedang1/2: %g %g\n",dedang1,dedang2); - } + /* + printf("BiTorsion: %d %d %d %d %d: angle12 %g %g: eng %g\n", + atom->tag[ia], + atom->tag[ib], + atom->tag[ic], + atom->tag[id], + atom->tag[ie], + angle1,angle2,e); + */ // fraction of energy for each atom @@ -1278,7 +1260,7 @@ void FixAmoebaBiTorsion::bcuint1(double *y, double *y1, ansy = ansy1 = ansy2 = 0.0; - for (int i = 4; i >= 1; i--) { + for (int i = 3; i >= 0; i--) { ansy = t*ansy + ((c[i][3]*u+c[i][2])*u+c[i][1])*u + c[i][0]; ansy1 = u*ansy1 + (3.0*c[3][i]*t+2.0*c[2][i])*t + c[1][i]; ansy2 = t*ansy2 + (3.0*c[i][3]*u+2.0*c[i][2])*u + c[i][1]; From d10407006670348ff76be91aaaf5256ee2088c6f Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Wed, 30 Mar 2022 17:15:18 -0600 Subject: [PATCH 098/585] add option for dynamics to in.ubiquitin --- examples/amoeba/in.ubiquitin | 9 ++++++++- 1 file changed, 8 insertions(+), 1 deletion(-) diff --git a/examples/amoeba/in.ubiquitin b/examples/amoeba/in.ubiquitin index d297cf01cc..d5fc3b0079 100644 --- a/examples/amoeba/in.ubiquitin +++ b/examples/amoeba/in.ubiquitin @@ -43,4 +43,11 @@ thermo_style custom step temp epair ebond eangle edihed eimp & # zero step run -run 0 +run 0 + +# dynamics + +#fix 1 all nve + +#thermo 1 +#run 100 From 7ec3017b85a8988aeab54e04eab928eb7c399782 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Thu, 31 Mar 2022 15:17:08 -0600 Subject: [PATCH 099/585] recreate data files for water examples --- examples/amoeba/data.water_box.amoeba | 450 +++++++++++----------- examples/amoeba/data.water_box.hippo | 450 +++++++++++----------- examples/amoeba/data.water_dimer.amoeba | 16 +- examples/amoeba/data.water_dimer.hippo | 16 +- examples/amoeba/data.water_hexamer.amoeba | 24 +- examples/amoeba/data.water_hexamer.hippo | 24 +- examples/amoeba/in.water_box.amoeba | 8 +- examples/amoeba/in.water_box.hippo | 8 +- examples/amoeba/in.water_dimer.amoeba | 8 +- examples/amoeba/in.water_dimer.hippo | 8 +- examples/amoeba/in.water_hexamer.amoeba | 8 +- examples/amoeba/in.water_hexamer.hippo | 8 +- 12 files changed, 556 insertions(+), 472 deletions(-) diff --git a/examples/amoeba/data.water_box.amoeba b/examples/amoeba/data.water_box.amoeba index 6f513c0234..94b507f765 100644 --- a/examples/amoeba/data.water_box.amoeba +++ b/examples/amoeba/data.water_box.amoeba @@ -1,4 +1,4 @@ -LAMMPS data file created from Tinker watersmall.xyz and amoeba.prm files +LAMMPS data file created from Tinker water_box.xyz and amoeba_water.prm files 648 atoms 432 bonds @@ -6,9 +6,9 @@ LAMMPS data file created from Tinker watersmall.xyz and amoeba.prm files 2 atom types 1 bond types 1 angle types --9.869157 9.999917 xlo xhi --10.006163 10.191392 ylo yhi --9.986525 10.056536 zlo zhi +0 18.643 xlo xhi +0 18.643 ylo yhi +0 18.643 zlo zhi Masses @@ -1103,222 +1103,222 @@ Bonds Angles -1 1 2 1 3 -2 1 5 4 6 -3 1 8 7 9 -4 1 11 10 12 -5 1 14 13 15 -6 1 17 16 18 -7 1 20 19 21 -8 1 23 22 24 -9 1 26 25 27 -10 1 29 28 30 -11 1 32 31 33 -12 1 35 34 36 -13 1 38 37 39 -14 1 41 40 42 -15 1 44 43 45 -16 1 47 46 48 -17 1 50 49 51 -18 1 53 52 54 -19 1 56 55 57 -20 1 59 58 60 -21 1 62 61 63 -22 1 65 64 66 -23 1 68 67 69 -24 1 71 70 72 -25 1 74 73 75 -26 1 77 76 78 -27 1 80 79 81 -28 1 83 82 84 -29 1 86 85 87 -30 1 89 88 90 -31 1 92 91 93 -32 1 95 94 96 -33 1 98 97 99 -34 1 101 100 102 -35 1 104 103 105 -36 1 107 106 108 -37 1 110 109 111 -38 1 113 112 114 -39 1 116 115 117 -40 1 119 118 120 -41 1 122 121 123 -42 1 125 124 126 -43 1 128 127 129 -44 1 131 130 132 -45 1 134 133 135 -46 1 137 136 138 -47 1 140 139 141 -48 1 143 142 144 -49 1 146 145 147 -50 1 149 148 150 -51 1 152 151 153 -52 1 155 154 156 -53 1 158 157 159 -54 1 161 160 162 -55 1 164 163 165 -56 1 167 166 168 -57 1 170 169 171 -58 1 173 172 174 -59 1 176 175 177 -60 1 179 178 180 -61 1 182 181 183 -62 1 185 184 186 -63 1 188 187 189 -64 1 191 190 192 -65 1 194 193 195 -66 1 197 196 198 -67 1 200 199 201 -68 1 203 202 204 -69 1 206 205 207 -70 1 209 208 210 -71 1 212 211 213 -72 1 215 214 216 -73 1 218 217 219 -74 1 221 220 222 -75 1 224 223 225 -76 1 227 226 228 -77 1 230 229 231 -78 1 233 232 234 -79 1 236 235 237 -80 1 239 238 240 -81 1 242 241 243 -82 1 245 244 246 -83 1 248 247 249 -84 1 251 250 252 -85 1 254 253 255 -86 1 257 256 258 -87 1 260 259 261 -88 1 263 262 264 -89 1 266 265 267 -90 1 269 268 270 -91 1 272 271 273 -92 1 275 274 276 -93 1 278 277 279 -94 1 281 280 282 -95 1 284 283 285 -96 1 287 286 288 -97 1 290 289 291 -98 1 293 292 294 -99 1 296 295 297 -100 1 299 298 300 -101 1 302 301 303 -102 1 305 304 306 -103 1 308 307 309 -104 1 311 310 312 -105 1 314 313 315 -106 1 317 316 318 -107 1 320 319 321 -108 1 323 322 324 -109 1 326 325 327 -110 1 329 328 330 -111 1 332 331 333 -112 1 335 334 336 -113 1 338 337 339 -114 1 341 340 342 -115 1 344 343 345 -116 1 347 346 348 -117 1 350 349 351 -118 1 353 352 354 -119 1 356 355 357 -120 1 359 358 360 -121 1 362 361 363 -122 1 365 364 366 -123 1 368 367 369 -124 1 371 370 372 -125 1 374 373 375 -126 1 377 376 378 -127 1 380 379 381 -128 1 383 382 384 -129 1 386 385 387 -130 1 389 388 390 -131 1 392 391 393 -132 1 395 394 396 -133 1 398 397 399 -134 1 401 400 402 -135 1 404 403 405 -136 1 407 406 408 -137 1 410 409 411 -138 1 413 412 414 -139 1 416 415 417 -140 1 419 418 420 -141 1 422 421 423 -142 1 425 424 426 -143 1 428 427 429 -144 1 431 430 432 -145 1 434 433 435 -146 1 437 436 438 -147 1 440 439 441 -148 1 443 442 444 -149 1 446 445 447 -150 1 449 448 450 -151 1 452 451 453 -152 1 455 454 456 -153 1 458 457 459 -154 1 461 460 462 -155 1 464 463 465 -156 1 467 466 468 -157 1 470 469 471 -158 1 473 472 474 -159 1 476 475 477 -160 1 479 478 480 -161 1 482 481 483 -162 1 485 484 486 -163 1 488 487 489 -164 1 491 490 492 -165 1 494 493 495 -166 1 497 496 498 -167 1 500 499 501 -168 1 503 502 504 -169 1 506 505 507 -170 1 509 508 510 -171 1 512 511 513 -172 1 515 514 516 -173 1 518 517 519 -174 1 521 520 522 -175 1 524 523 525 -176 1 527 526 528 -177 1 530 529 531 -178 1 533 532 534 -179 1 536 535 537 -180 1 539 538 540 -181 1 542 541 543 -182 1 545 544 546 -183 1 548 547 549 -184 1 551 550 552 -185 1 554 553 555 -186 1 557 556 558 -187 1 560 559 561 -188 1 563 562 564 -189 1 566 565 567 -190 1 569 568 570 -191 1 572 571 573 -192 1 575 574 576 -193 1 578 577 579 -194 1 581 580 582 -195 1 584 583 585 -196 1 587 586 588 -197 1 590 589 591 -198 1 593 592 594 -199 1 596 595 597 -200 1 599 598 600 -201 1 602 601 603 -202 1 605 604 606 -203 1 608 607 609 -204 1 611 610 612 -205 1 614 613 615 -206 1 617 616 618 -207 1 620 619 621 -208 1 623 622 624 -209 1 626 625 627 -210 1 629 628 630 -211 1 632 631 633 -212 1 635 634 636 -213 1 638 637 639 -214 1 641 640 642 -215 1 644 643 645 -216 1 647 646 648 +1 1 3 1 2 +2 1 6 4 5 +3 1 9 7 8 +4 1 12 10 11 +5 1 15 13 14 +6 1 18 16 17 +7 1 21 19 20 +8 1 24 22 23 +9 1 27 25 26 +10 1 30 28 29 +11 1 33 31 32 +12 1 36 34 35 +13 1 39 37 38 +14 1 42 40 41 +15 1 45 43 44 +16 1 48 46 47 +17 1 51 49 50 +18 1 54 52 53 +19 1 57 55 56 +20 1 60 58 59 +21 1 63 61 62 +22 1 66 64 65 +23 1 69 67 68 +24 1 72 70 71 +25 1 75 73 74 +26 1 78 76 77 +27 1 81 79 80 +28 1 84 82 83 +29 1 87 85 86 +30 1 90 88 89 +31 1 93 91 92 +32 1 96 94 95 +33 1 99 97 98 +34 1 102 100 101 +35 1 105 103 104 +36 1 108 106 107 +37 1 111 109 110 +38 1 114 112 113 +39 1 117 115 116 +40 1 120 118 119 +41 1 123 121 122 +42 1 126 124 125 +43 1 129 127 128 +44 1 132 130 131 +45 1 135 133 134 +46 1 138 136 137 +47 1 141 139 140 +48 1 144 142 143 +49 1 147 145 146 +50 1 150 148 149 +51 1 153 151 152 +52 1 156 154 155 +53 1 159 157 158 +54 1 162 160 161 +55 1 165 163 164 +56 1 168 166 167 +57 1 171 169 170 +58 1 174 172 173 +59 1 177 175 176 +60 1 180 178 179 +61 1 183 181 182 +62 1 186 184 185 +63 1 189 187 188 +64 1 192 190 191 +65 1 195 193 194 +66 1 198 196 197 +67 1 201 199 200 +68 1 204 202 203 +69 1 207 205 206 +70 1 210 208 209 +71 1 213 211 212 +72 1 216 214 215 +73 1 219 217 218 +74 1 222 220 221 +75 1 225 223 224 +76 1 228 226 227 +77 1 231 229 230 +78 1 234 232 233 +79 1 237 235 236 +80 1 240 238 239 +81 1 243 241 242 +82 1 246 244 245 +83 1 249 247 248 +84 1 252 250 251 +85 1 255 253 254 +86 1 258 256 257 +87 1 261 259 260 +88 1 264 262 263 +89 1 267 265 266 +90 1 270 268 269 +91 1 273 271 272 +92 1 276 274 275 +93 1 279 277 278 +94 1 282 280 281 +95 1 285 283 284 +96 1 288 286 287 +97 1 291 289 290 +98 1 294 292 293 +99 1 297 295 296 +100 1 300 298 299 +101 1 303 301 302 +102 1 306 304 305 +103 1 309 307 308 +104 1 312 310 311 +105 1 315 313 314 +106 1 318 316 317 +107 1 321 319 320 +108 1 324 322 323 +109 1 327 325 326 +110 1 330 328 329 +111 1 333 331 332 +112 1 336 334 335 +113 1 339 337 338 +114 1 342 340 341 +115 1 345 343 344 +116 1 348 346 347 +117 1 351 349 350 +118 1 354 352 353 +119 1 357 355 356 +120 1 360 358 359 +121 1 363 361 362 +122 1 366 364 365 +123 1 369 367 368 +124 1 372 370 371 +125 1 375 373 374 +126 1 378 376 377 +127 1 381 379 380 +128 1 384 382 383 +129 1 387 385 386 +130 1 390 388 389 +131 1 393 391 392 +132 1 396 394 395 +133 1 399 397 398 +134 1 402 400 401 +135 1 405 403 404 +136 1 408 406 407 +137 1 411 409 410 +138 1 414 412 413 +139 1 417 415 416 +140 1 420 418 419 +141 1 423 421 422 +142 1 426 424 425 +143 1 429 427 428 +144 1 432 430 431 +145 1 435 433 434 +146 1 438 436 437 +147 1 441 439 440 +148 1 444 442 443 +149 1 447 445 446 +150 1 450 448 449 +151 1 453 451 452 +152 1 456 454 455 +153 1 459 457 458 +154 1 462 460 461 +155 1 465 463 464 +156 1 468 466 467 +157 1 471 469 470 +158 1 474 472 473 +159 1 477 475 476 +160 1 480 478 479 +161 1 483 481 482 +162 1 486 484 485 +163 1 489 487 488 +164 1 492 490 491 +165 1 495 493 494 +166 1 498 496 497 +167 1 501 499 500 +168 1 504 502 503 +169 1 507 505 506 +170 1 510 508 509 +171 1 513 511 512 +172 1 516 514 515 +173 1 519 517 518 +174 1 522 520 521 +175 1 525 523 524 +176 1 528 526 527 +177 1 531 529 530 +178 1 534 532 533 +179 1 537 535 536 +180 1 540 538 539 +181 1 543 541 542 +182 1 546 544 545 +183 1 549 547 548 +184 1 552 550 551 +185 1 555 553 554 +186 1 558 556 557 +187 1 561 559 560 +188 1 564 562 563 +189 1 567 565 566 +190 1 570 568 569 +191 1 573 571 572 +192 1 576 574 575 +193 1 579 577 578 +194 1 582 580 581 +195 1 585 583 584 +196 1 588 586 587 +197 1 591 589 590 +198 1 594 592 593 +199 1 597 595 596 +200 1 600 598 599 +201 1 603 601 602 +202 1 606 604 605 +203 1 609 607 608 +204 1 612 610 611 +205 1 615 613 614 +206 1 618 616 617 +207 1 621 619 620 +208 1 624 622 623 +209 1 627 625 626 +210 1 630 628 629 +211 1 633 631 632 +212 1 636 634 635 +213 1 639 637 638 +214 1 642 640 641 +215 1 645 643 644 +216 1 648 646 647 Bond Coeffs @@ -1326,7 +1326,15 @@ Bond Coeffs Angle Coeffs -1 0 108.5 48.7 -39.064262472 8.95286947775 -6.41202044508 11.5462823034 +1 0 1 108.5 48.7 -39.064262472 8.95286947775 -6.41202044508 11.5462823034 + +BondAngle Coeffs + +1 0.0 0.0 0.0 0.0 + +UreyBradley Coeffs + +1 -7.6 1.5537 Tinker Types diff --git a/examples/amoeba/data.water_box.hippo b/examples/amoeba/data.water_box.hippo index 61b0dcbede..d2e38989be 100644 --- a/examples/amoeba/data.water_box.hippo +++ b/examples/amoeba/data.water_box.hippo @@ -1,4 +1,4 @@ -LAMMPS data file created from Tinker watersmall.xyz and hippo.prm files +LAMMPS data file created from Tinker water_box.xyz and hippo_water.prm files 648 atoms 432 bonds @@ -6,9 +6,9 @@ LAMMPS data file created from Tinker watersmall.xyz and hippo.prm files 2 atom types 1 bond types 1 angle types --9.869157 9.999917 xlo xhi --10.006163 10.191392 ylo yhi --9.986525 10.056536 zlo zhi +0 18.643 xlo xhi +0 18.643 ylo yhi +0 18.643 zlo zhi Masses @@ -1103,222 +1103,222 @@ Bonds Angles -1 1 2 1 3 -2 1 5 4 6 -3 1 8 7 9 -4 1 11 10 12 -5 1 14 13 15 -6 1 17 16 18 -7 1 20 19 21 -8 1 23 22 24 -9 1 26 25 27 -10 1 29 28 30 -11 1 32 31 33 -12 1 35 34 36 -13 1 38 37 39 -14 1 41 40 42 -15 1 44 43 45 -16 1 47 46 48 -17 1 50 49 51 -18 1 53 52 54 -19 1 56 55 57 -20 1 59 58 60 -21 1 62 61 63 -22 1 65 64 66 -23 1 68 67 69 -24 1 71 70 72 -25 1 74 73 75 -26 1 77 76 78 -27 1 80 79 81 -28 1 83 82 84 -29 1 86 85 87 -30 1 89 88 90 -31 1 92 91 93 -32 1 95 94 96 -33 1 98 97 99 -34 1 101 100 102 -35 1 104 103 105 -36 1 107 106 108 -37 1 110 109 111 -38 1 113 112 114 -39 1 116 115 117 -40 1 119 118 120 -41 1 122 121 123 -42 1 125 124 126 -43 1 128 127 129 -44 1 131 130 132 -45 1 134 133 135 -46 1 137 136 138 -47 1 140 139 141 -48 1 143 142 144 -49 1 146 145 147 -50 1 149 148 150 -51 1 152 151 153 -52 1 155 154 156 -53 1 158 157 159 -54 1 161 160 162 -55 1 164 163 165 -56 1 167 166 168 -57 1 170 169 171 -58 1 173 172 174 -59 1 176 175 177 -60 1 179 178 180 -61 1 182 181 183 -62 1 185 184 186 -63 1 188 187 189 -64 1 191 190 192 -65 1 194 193 195 -66 1 197 196 198 -67 1 200 199 201 -68 1 203 202 204 -69 1 206 205 207 -70 1 209 208 210 -71 1 212 211 213 -72 1 215 214 216 -73 1 218 217 219 -74 1 221 220 222 -75 1 224 223 225 -76 1 227 226 228 -77 1 230 229 231 -78 1 233 232 234 -79 1 236 235 237 -80 1 239 238 240 -81 1 242 241 243 -82 1 245 244 246 -83 1 248 247 249 -84 1 251 250 252 -85 1 254 253 255 -86 1 257 256 258 -87 1 260 259 261 -88 1 263 262 264 -89 1 266 265 267 -90 1 269 268 270 -91 1 272 271 273 -92 1 275 274 276 -93 1 278 277 279 -94 1 281 280 282 -95 1 284 283 285 -96 1 287 286 288 -97 1 290 289 291 -98 1 293 292 294 -99 1 296 295 297 -100 1 299 298 300 -101 1 302 301 303 -102 1 305 304 306 -103 1 308 307 309 -104 1 311 310 312 -105 1 314 313 315 -106 1 317 316 318 -107 1 320 319 321 -108 1 323 322 324 -109 1 326 325 327 -110 1 329 328 330 -111 1 332 331 333 -112 1 335 334 336 -113 1 338 337 339 -114 1 341 340 342 -115 1 344 343 345 -116 1 347 346 348 -117 1 350 349 351 -118 1 353 352 354 -119 1 356 355 357 -120 1 359 358 360 -121 1 362 361 363 -122 1 365 364 366 -123 1 368 367 369 -124 1 371 370 372 -125 1 374 373 375 -126 1 377 376 378 -127 1 380 379 381 -128 1 383 382 384 -129 1 386 385 387 -130 1 389 388 390 -131 1 392 391 393 -132 1 395 394 396 -133 1 398 397 399 -134 1 401 400 402 -135 1 404 403 405 -136 1 407 406 408 -137 1 410 409 411 -138 1 413 412 414 -139 1 416 415 417 -140 1 419 418 420 -141 1 422 421 423 -142 1 425 424 426 -143 1 428 427 429 -144 1 431 430 432 -145 1 434 433 435 -146 1 437 436 438 -147 1 440 439 441 -148 1 443 442 444 -149 1 446 445 447 -150 1 449 448 450 -151 1 452 451 453 -152 1 455 454 456 -153 1 458 457 459 -154 1 461 460 462 -155 1 464 463 465 -156 1 467 466 468 -157 1 470 469 471 -158 1 473 472 474 -159 1 476 475 477 -160 1 479 478 480 -161 1 482 481 483 -162 1 485 484 486 -163 1 488 487 489 -164 1 491 490 492 -165 1 494 493 495 -166 1 497 496 498 -167 1 500 499 501 -168 1 503 502 504 -169 1 506 505 507 -170 1 509 508 510 -171 1 512 511 513 -172 1 515 514 516 -173 1 518 517 519 -174 1 521 520 522 -175 1 524 523 525 -176 1 527 526 528 -177 1 530 529 531 -178 1 533 532 534 -179 1 536 535 537 -180 1 539 538 540 -181 1 542 541 543 -182 1 545 544 546 -183 1 548 547 549 -184 1 551 550 552 -185 1 554 553 555 -186 1 557 556 558 -187 1 560 559 561 -188 1 563 562 564 -189 1 566 565 567 -190 1 569 568 570 -191 1 572 571 573 -192 1 575 574 576 -193 1 578 577 579 -194 1 581 580 582 -195 1 584 583 585 -196 1 587 586 588 -197 1 590 589 591 -198 1 593 592 594 -199 1 596 595 597 -200 1 599 598 600 -201 1 602 601 603 -202 1 605 604 606 -203 1 608 607 609 -204 1 611 610 612 -205 1 614 613 615 -206 1 617 616 618 -207 1 620 619 621 -208 1 623 622 624 -209 1 626 625 627 -210 1 629 628 630 -211 1 632 631 633 -212 1 635 634 636 -213 1 638 637 639 -214 1 641 640 642 -215 1 644 643 645 -216 1 647 646 648 +1 1 3 1 2 +2 1 6 4 5 +3 1 9 7 8 +4 1 12 10 11 +5 1 15 13 14 +6 1 18 16 17 +7 1 21 19 20 +8 1 24 22 23 +9 1 27 25 26 +10 1 30 28 29 +11 1 33 31 32 +12 1 36 34 35 +13 1 39 37 38 +14 1 42 40 41 +15 1 45 43 44 +16 1 48 46 47 +17 1 51 49 50 +18 1 54 52 53 +19 1 57 55 56 +20 1 60 58 59 +21 1 63 61 62 +22 1 66 64 65 +23 1 69 67 68 +24 1 72 70 71 +25 1 75 73 74 +26 1 78 76 77 +27 1 81 79 80 +28 1 84 82 83 +29 1 87 85 86 +30 1 90 88 89 +31 1 93 91 92 +32 1 96 94 95 +33 1 99 97 98 +34 1 102 100 101 +35 1 105 103 104 +36 1 108 106 107 +37 1 111 109 110 +38 1 114 112 113 +39 1 117 115 116 +40 1 120 118 119 +41 1 123 121 122 +42 1 126 124 125 +43 1 129 127 128 +44 1 132 130 131 +45 1 135 133 134 +46 1 138 136 137 +47 1 141 139 140 +48 1 144 142 143 +49 1 147 145 146 +50 1 150 148 149 +51 1 153 151 152 +52 1 156 154 155 +53 1 159 157 158 +54 1 162 160 161 +55 1 165 163 164 +56 1 168 166 167 +57 1 171 169 170 +58 1 174 172 173 +59 1 177 175 176 +60 1 180 178 179 +61 1 183 181 182 +62 1 186 184 185 +63 1 189 187 188 +64 1 192 190 191 +65 1 195 193 194 +66 1 198 196 197 +67 1 201 199 200 +68 1 204 202 203 +69 1 207 205 206 +70 1 210 208 209 +71 1 213 211 212 +72 1 216 214 215 +73 1 219 217 218 +74 1 222 220 221 +75 1 225 223 224 +76 1 228 226 227 +77 1 231 229 230 +78 1 234 232 233 +79 1 237 235 236 +80 1 240 238 239 +81 1 243 241 242 +82 1 246 244 245 +83 1 249 247 248 +84 1 252 250 251 +85 1 255 253 254 +86 1 258 256 257 +87 1 261 259 260 +88 1 264 262 263 +89 1 267 265 266 +90 1 270 268 269 +91 1 273 271 272 +92 1 276 274 275 +93 1 279 277 278 +94 1 282 280 281 +95 1 285 283 284 +96 1 288 286 287 +97 1 291 289 290 +98 1 294 292 293 +99 1 297 295 296 +100 1 300 298 299 +101 1 303 301 302 +102 1 306 304 305 +103 1 309 307 308 +104 1 312 310 311 +105 1 315 313 314 +106 1 318 316 317 +107 1 321 319 320 +108 1 324 322 323 +109 1 327 325 326 +110 1 330 328 329 +111 1 333 331 332 +112 1 336 334 335 +113 1 339 337 338 +114 1 342 340 341 +115 1 345 343 344 +116 1 348 346 347 +117 1 351 349 350 +118 1 354 352 353 +119 1 357 355 356 +120 1 360 358 359 +121 1 363 361 362 +122 1 366 364 365 +123 1 369 367 368 +124 1 372 370 371 +125 1 375 373 374 +126 1 378 376 377 +127 1 381 379 380 +128 1 384 382 383 +129 1 387 385 386 +130 1 390 388 389 +131 1 393 391 392 +132 1 396 394 395 +133 1 399 397 398 +134 1 402 400 401 +135 1 405 403 404 +136 1 408 406 407 +137 1 411 409 410 +138 1 414 412 413 +139 1 417 415 416 +140 1 420 418 419 +141 1 423 421 422 +142 1 426 424 425 +143 1 429 427 428 +144 1 432 430 431 +145 1 435 433 434 +146 1 438 436 437 +147 1 441 439 440 +148 1 444 442 443 +149 1 447 445 446 +150 1 450 448 449 +151 1 453 451 452 +152 1 456 454 455 +153 1 459 457 458 +154 1 462 460 461 +155 1 465 463 464 +156 1 468 466 467 +157 1 471 469 470 +158 1 474 472 473 +159 1 477 475 476 +160 1 480 478 479 +161 1 483 481 482 +162 1 486 484 485 +163 1 489 487 488 +164 1 492 490 491 +165 1 495 493 494 +166 1 498 496 497 +167 1 501 499 500 +168 1 504 502 503 +169 1 507 505 506 +170 1 510 508 509 +171 1 513 511 512 +172 1 516 514 515 +173 1 519 517 518 +174 1 522 520 521 +175 1 525 523 524 +176 1 528 526 527 +177 1 531 529 530 +178 1 534 532 533 +179 1 537 535 536 +180 1 540 538 539 +181 1 543 541 542 +182 1 546 544 545 +183 1 549 547 548 +184 1 552 550 551 +185 1 555 553 554 +186 1 558 556 557 +187 1 561 559 560 +188 1 564 562 563 +189 1 567 565 566 +190 1 570 568 569 +191 1 573 571 572 +192 1 576 574 575 +193 1 579 577 578 +194 1 582 580 581 +195 1 585 583 584 +196 1 588 586 587 +197 1 591 589 590 +198 1 594 592 593 +199 1 597 595 596 +200 1 600 598 599 +201 1 603 601 602 +202 1 606 604 605 +203 1 609 607 608 +204 1 612 610 611 +205 1 615 613 614 +206 1 618 616 617 +207 1 621 619 620 +208 1 624 622 623 +209 1 627 625 626 +210 1 630 628 629 +211 1 633 631 632 +212 1 636 634 635 +213 1 639 637 638 +214 1 642 640 641 +215 1 645 643 644 +216 1 648 646 647 Bond Coeffs @@ -1326,7 +1326,15 @@ Bond Coeffs Angle Coeffs -1 0 107.7 48.7 -39.064262472 8.95286947775 -6.41202044508 11.5462823034 +1 0 0 107.7 48.7 -39.064262472 8.95286947775 -6.41202044508 11.5462823034 + +BondAngle Coeffs + +1 0.0 0.0 0.0 0.0 + +UreyBradley Coeffs + +1 0.0 0.0 Tinker Types diff --git a/examples/amoeba/data.water_dimer.amoeba b/examples/amoeba/data.water_dimer.amoeba index 50b2b7dde7..cb853e35df 100644 --- a/examples/amoeba/data.water_dimer.amoeba +++ b/examples/amoeba/data.water_dimer.amoeba @@ -1,4 +1,4 @@ -LAMMPS data file created from Tinker ../TINKER_TESTS/water_dimer/water_dimer.xyz and ../TINKER_TESTS/water_dimer/amoeba.prm files +LAMMPS data file created from Tinker water_dimer.xyz and amoeba_water.prm files 6 atoms 4 bonds @@ -33,8 +33,8 @@ Bonds Angles -1 1 2 1 3 -2 1 5 4 6 +1 1 3 1 2 +2 1 6 4 5 Bond Coeffs @@ -42,7 +42,15 @@ Bond Coeffs Angle Coeffs -1 0 108.5 48.7 -39.064262472 8.95286947775 -6.41202044508 11.5462823034 +1 0 1 108.5 48.7 -39.064262472 8.95286947775 -6.41202044508 11.5462823034 + +BondAngle Coeffs + +1 0.0 0.0 0.0 0.0 + +UreyBradley Coeffs + +1 -7.6 1.5537 Tinker Types diff --git a/examples/amoeba/data.water_dimer.hippo b/examples/amoeba/data.water_dimer.hippo index 40709ab1be..5cdd388a09 100644 --- a/examples/amoeba/data.water_dimer.hippo +++ b/examples/amoeba/data.water_dimer.hippo @@ -1,4 +1,4 @@ -LAMMPS data file created from Tinker water_dimer.xyz and hippo.prm files +LAMMPS data file created from Tinker water_dimer.xyz and hippo_water.prm files 6 atoms 4 bonds @@ -33,8 +33,8 @@ Bonds Angles -1 1 2 1 3 -2 1 5 4 6 +1 1 3 1 2 +2 1 6 4 5 Bond Coeffs @@ -42,7 +42,15 @@ Bond Coeffs Angle Coeffs -1 0 107.7 48.7 -39.064262472 8.95286947775 -6.41202044508 11.5462823034 +1 0 0 107.7 48.7 -39.064262472 8.95286947775 -6.41202044508 11.5462823034 + +BondAngle Coeffs + +1 0.0 0.0 0.0 0.0 + +UreyBradley Coeffs + +1 0.0 0.0 Tinker Types diff --git a/examples/amoeba/data.water_hexamer.amoeba b/examples/amoeba/data.water_hexamer.amoeba index ed76cc5186..9197df6ccd 100644 --- a/examples/amoeba/data.water_hexamer.amoeba +++ b/examples/amoeba/data.water_hexamer.amoeba @@ -1,4 +1,4 @@ -LAMMPS data file created from Tinker water_hexamer.xyz and amoeba.prm files +LAMMPS data file created from Tinker water_hexamer.xyz and amoeba_water.prm files 18 atoms 12 bonds @@ -53,12 +53,12 @@ Bonds Angles -1 1 2 1 3 -2 1 5 4 6 -3 1 8 7 9 -4 1 11 10 12 -5 1 14 13 15 -6 1 17 16 18 +1 1 3 1 2 +2 1 6 4 5 +3 1 9 7 8 +4 1 12 10 11 +5 1 15 13 14 +6 1 18 16 17 Bond Coeffs @@ -66,7 +66,15 @@ Bond Coeffs Angle Coeffs -1 0 108.5 48.7 -39.064262472 8.95286947775 -6.41202044508 11.5462823034 +1 0 1 108.5 48.7 -39.064262472 8.95286947775 -6.41202044508 11.5462823034 + +BondAngle Coeffs + +1 0.0 0.0 0.0 0.0 + +UreyBradley Coeffs + +1 -7.6 1.5537 Tinker Types diff --git a/examples/amoeba/data.water_hexamer.hippo b/examples/amoeba/data.water_hexamer.hippo index 69afeefed5..a987f8cdb6 100644 --- a/examples/amoeba/data.water_hexamer.hippo +++ b/examples/amoeba/data.water_hexamer.hippo @@ -1,4 +1,4 @@ -LAMMPS data file created from Tinker water_hexamer.xyz and hippo.prm files +LAMMPS data file created from Tinker water_hexamer.xyz and hippo_water.prm files 18 atoms 12 bonds @@ -53,12 +53,12 @@ Bonds Angles -1 1 2 1 3 -2 1 5 4 6 -3 1 8 7 9 -4 1 11 10 12 -5 1 14 13 15 -6 1 17 16 18 +1 1 3 1 2 +2 1 6 4 5 +3 1 9 7 8 +4 1 12 10 11 +5 1 15 13 14 +6 1 18 16 17 Bond Coeffs @@ -66,7 +66,15 @@ Bond Coeffs Angle Coeffs -1 0 107.7 48.7 -39.064262472 8.95286947775 -6.41202044508 11.5462823034 +1 0 0 107.7 48.7 -39.064262472 8.95286947775 -6.41202044508 11.5462823034 + +BondAngle Coeffs + +1 0.0 0.0 0.0 0.0 + +UreyBradley Coeffs + +1 0.0 0.0 Tinker Types diff --git a/examples/amoeba/in.water_box.amoeba b/examples/amoeba/in.water_box.amoeba index 961a81d8b4..5cf3b3b98c 100644 --- a/examples/amoeba/in.water_box.amoeba +++ b/examples/amoeba/in.water_box.amoeba @@ -35,4 +35,10 @@ thermo_style custom step temp epair ebond eangle edihed eimp & # zero step run -run 0 +#run 0 + +# dynamics + +thermo 1 +fix 1 all nve +run 100 diff --git a/examples/amoeba/in.water_box.hippo b/examples/amoeba/in.water_box.hippo index 5f8dc1efd3..7a2c4805e6 100644 --- a/examples/amoeba/in.water_box.hippo +++ b/examples/amoeba/in.water_box.hippo @@ -35,4 +35,10 @@ thermo_style custom step temp epair ebond eangle edihed eimp & # zero step run -run 0 +#run 0 + +# dynamics + +thermo 1 +fix 1 all nve +run 100 diff --git a/examples/amoeba/in.water_dimer.amoeba b/examples/amoeba/in.water_dimer.amoeba index fbeded4837..c0e6ee35e4 100644 --- a/examples/amoeba/in.water_dimer.amoeba +++ b/examples/amoeba/in.water_dimer.amoeba @@ -35,4 +35,10 @@ thermo_style custom step temp epair ebond eangle edihed eimp & # zero step run -run 0 +#run 0 + +# dynamics + +thermo 1 +fix 1 all nve +run 100 diff --git a/examples/amoeba/in.water_dimer.hippo b/examples/amoeba/in.water_dimer.hippo index 59ff9cc5a7..55b173b789 100644 --- a/examples/amoeba/in.water_dimer.hippo +++ b/examples/amoeba/in.water_dimer.hippo @@ -35,4 +35,10 @@ thermo_style custom step temp epair ebond eangle edihed eimp & # zero step run -run 0 +#run 0 + +# dynamics + +thermo 1 +fix 1 all nve +run 100 diff --git a/examples/amoeba/in.water_hexamer.amoeba b/examples/amoeba/in.water_hexamer.amoeba index 5f02dbd41d..bc742f3089 100644 --- a/examples/amoeba/in.water_hexamer.amoeba +++ b/examples/amoeba/in.water_hexamer.amoeba @@ -35,4 +35,10 @@ thermo_style custom step temp epair ebond eangle edihed eimp & # zero step run -run 0 +#run 0 + +# dynamics + +thermo 1 +fix 1 all nve +run 100 diff --git a/examples/amoeba/in.water_hexamer.hippo b/examples/amoeba/in.water_hexamer.hippo index 3ba2379326..bb5cf9e910 100644 --- a/examples/amoeba/in.water_hexamer.hippo +++ b/examples/amoeba/in.water_hexamer.hippo @@ -35,4 +35,10 @@ thermo_style custom step temp epair ebond eangle edihed eimp & # zero step run -run 0 +#run 0 + +# dynamics + +thermo 1 +fix 1 all nve +run 100 From 46f88011bda04d844b39c935a544450d6f4a34ad Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Mon, 4 Apr 2022 17:01:10 -0600 Subject: [PATCH 100/585] input syntax include/exclude bug --- src/AMOEBA/pair_amoeba.cpp | 6 +++--- 1 file changed, 3 insertions(+), 3 deletions(-) diff --git a/src/AMOEBA/pair_amoeba.cpp b/src/AMOEBA/pair_amoeba.cpp index e64377d9b9..4288de6e36 100644 --- a/src/AMOEBA/pair_amoeba.cpp +++ b/src/AMOEBA/pair_amoeba.cpp @@ -568,15 +568,15 @@ void PairAmoeba::settings(int narg, char **arg) else if (strcmp(arg[iarg],"disp") == 0) disp_rspace_flag = disp_kspace_flag = newvalue; else if (strcmp(arg[iarg],"disp/rspace") == 0) disp_rspace_flag = newvalue; - else if (strcmp(arg[iarg],"disp/kspace") == 0) disp_rspace_flag = newvalue; + else if (strcmp(arg[iarg],"disp/kspace") == 0) disp_kspace_flag = newvalue; else if (strcmp(arg[iarg],"polar") == 0) polar_rspace_flag = polar_kspace_flag = newvalue; else if (strcmp(arg[iarg],"polar/rspace") == 0) polar_rspace_flag = newvalue; - else if (strcmp(arg[iarg],"polar/kspace") == 0) polar_rspace_flag = newvalue; + else if (strcmp(arg[iarg],"polar/kspace") == 0) polar_kspace_flag = newvalue; else if (strcmp(arg[iarg],"mpole") == 0) mpole_rspace_flag = mpole_kspace_flag = newvalue; else if (strcmp(arg[iarg],"mpole/rspace") == 0) mpole_rspace_flag = newvalue; - else if (strcmp(arg[iarg],"mpole/kspace") == 0) mpole_rspace_flag = newvalue; + else if (strcmp(arg[iarg],"mpole/kspace") == 0) mpole_kspace_flag = newvalue; else if (strcmp(arg[iarg],"bond") == 0) bond_flag = newvalue; else if (strcmp(arg[iarg],"angle") == 0) angle_flag = newvalue; else if (strcmp(arg[iarg],"dihedral") == 0) dihedral_flag = newvalue; From 3039d107421a70b832c0bc8d08a8f3d9d6c3147c Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Fri, 8 Apr 2022 15:00:54 -0600 Subject: [PATCH 101/585] new key files for water box example --- examples/amoeba/amoeba_water_box.key | 19 +++++++++++++++++++ examples/amoeba/hippo_water_box.key | 22 ++++++++++++++++++++++ examples/amoeba/in.water_box.amoeba | 2 +- examples/amoeba/in.water_box.hippo | 2 +- 4 files changed, 43 insertions(+), 2 deletions(-) create mode 100644 examples/amoeba/amoeba_water_box.key create mode 100644 examples/amoeba/hippo_water_box.key diff --git a/examples/amoeba/amoeba_water_box.key b/examples/amoeba/amoeba_water_box.key new file mode 100644 index 0000000000..102be80d73 --- /dev/null +++ b/examples/amoeba/amoeba_water_box.key @@ -0,0 +1,19 @@ +parameters ./amoeba.prm + +digits 10 +openmp-threads 1 + +ewald +ewald-alpha 0.4 +pewald-alpha 0.5 +pme-grid 50 50 50 + +neighbor-list +a-axis 18.643 + +cutoff 7 +taper 6 + +polar-eps 1e-5 +usolve-diag 1.0 + diff --git a/examples/amoeba/hippo_water_box.key b/examples/amoeba/hippo_water_box.key new file mode 100644 index 0000000000..1dd89919ed --- /dev/null +++ b/examples/amoeba/hippo_water_box.key @@ -0,0 +1,22 @@ +parameters ./hippo.prm + +digits 8 +verbose + +ewald +ewald-alpha 0.4 +pewald-alpha 0.5 + +dewald +dewald-alpha 0.45 +dpme-grid 16 16 16 + +neighbor-list +a-axis 18.643 + +cutoff 7 +taper 6 + +polar-eps 1e-5 +usolve-diag 1.0 + diff --git a/examples/amoeba/in.water_box.amoeba b/examples/amoeba/in.water_box.amoeba index 5cf3b3b98c..3a37784f9d 100644 --- a/examples/amoeba/in.water_box.amoeba +++ b/examples/amoeba/in.water_box.amoeba @@ -22,7 +22,7 @@ read_data data.water_box.amoeba fix amtype NULL "Tinker Types" # force field pair_style amoeba -pair_coeff * * amoeba_water.prm amoeba_water.key +pair_coeff * * amoeba_water.prm amoeba_water_box.key special_bonds lj/coul 0.5 0.5 0.5 one/five yes diff --git a/examples/amoeba/in.water_box.hippo b/examples/amoeba/in.water_box.hippo index 7a2c4805e6..8e1d9a8e70 100644 --- a/examples/amoeba/in.water_box.hippo +++ b/examples/amoeba/in.water_box.hippo @@ -22,7 +22,7 @@ read_data data.water_box.hippo fix amtype NULL "Tinker Types" # force field pair_style hippo -pair_coeff * * hippo_water.prm hippo_water.key +pair_coeff * * hippo_water.prm hippo_water_box.key special_bonds lj/coul 0.5 0.5 0.5 one/five yes From 6ef7d19fc0a8a6180dd0c9ea3d4399c7d8143a0c Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Fri, 8 Apr 2022 15:05:17 -0600 Subject: [PATCH 102/585] Added a test for bgrid/local --- examples/snap/grid.local.py | 119 +++++++++++++++++++++++++++++ examples/snap/in.grid.python.local | 69 +++++++++++++++++ 2 files changed, 188 insertions(+) create mode 100755 examples/snap/grid.local.py create mode 100644 examples/snap/in.grid.python.local diff --git a/examples/snap/grid.local.py b/examples/snap/grid.local.py new file mode 100755 index 0000000000..8b8cb99d66 --- /dev/null +++ b/examples/snap/grid.local.py @@ -0,0 +1,119 @@ +#!/Users/athomps/miniconda3/bin/python3.7 +# +# An example of SNAP grid from LAMMPS Python interface +# +# https://lammps.sandia.gov/doc/Python_library.html + + +from lammps import lammps, LMP_STYLE_LOCAL, LMP_SIZE_ROWS, LMP_SIZE_COLS, LMP_TYPE_ARRAY +import lammps_utils + +from mpi4py import MPI +comm = MPI.COMM_WORLD +me = comm.Get_rank() +nprocs = comm.Get_size() + +# define command line input variables + +ngridx = 2 +ngridy = 3 +ngridz = nprocs +twojmax = 2 + +lmp_cmdargs = ["-echo","screen"] +lmp_cmdargs = lammps_utils.set_cmdlinevars(lmp_cmdargs, + { + "ngridx":ngridx, + "ngridy":ngridy, + "ngridz":ngridz, + "twojmax":twojmax + } + ) + +# launch LAMMPS instance + +lmp = lammps(cmdargs=lmp_cmdargs) + +# run LAMMPS input script + +lmp.file("in.grid.python.local") + +# get quantities from LAMMPS + +num_atoms = lmp.get_natoms() + +# set things not accessible from LAMMPS + +# first 3 cols are x, y, z, coords + +ncols0 = 3 + +# analytical relation + +ncoeff = (twojmax+2)*(twojmax+3)*(twojmax+4) +ncoeff = ncoeff // 24 # integer division +ncols = ncols0+ncoeff + +# get B_0 at position (0,0,0) in 4 different ways + +# 1. from comute sna/atom + +bptr = lmp.extract_compute("b", 1, 2) # 1 = per-atom data, 2 = array +print("b = ",bptr[0][0]) + +# 2. from compute sna/grid + +bgridptr = lmp.extract_compute("bgrid", 0, 2) # 0 = style global, 2 = type array +print("bgrid = ",bgridptr[0][3]) + +# 3. from Numpy array pointing to sna/atom array + +bptr_np = lammps_utils.extract_compute_np(lmp,"b",1,2,(num_atoms,ncoeff)) +print("b_np = ",bptr_np[0][0]) + +# 4. from Numpy array pointing to sna/grid array + +bgridptr_np = lammps_utils.extract_compute_np(lmp,"bgrid",0,2,(ngridz,ngridy,ngridx,ncols)) +print("bgrid_np = ",bgridptr_np[0][0][0][ncols0+0]) + +# 5. from sna/grid/local array + +bgridlocalnrows = lmp.extract_compute("bgridlocal", LMP_STYLE_LOCAL, LMP_SIZE_ROWS) +print("bgridlocal nrows = ",bgridlocalnrows) +bgridlocalncols = lmp.extract_compute("bgridlocal", LMP_STYLE_LOCAL, LMP_SIZE_COLS) +print("bgridlocal ncols = ",bgridlocalncols) +bgridlocalptr = lmp.extract_compute("bgridlocal", LMP_STYLE_LOCAL, LMP_TYPE_ARRAY) +print("bgridlocal = ",bgridlocalptr) +print("bgridlocal[0][0] = ",bgridlocalptr[5][10]) + +# print out the LAMMPS array to a file + +outfile = open("bgrid.dat",'w') +igrid = 0 +for iz in range(ngridz): + for iy in range(ngridy): + for ix in range(ngridx): + outfile.write("x, y, z = %g %g %g\n" % + (bgridptr[igrid][0], + bgridptr[igrid][1], + bgridptr[igrid][2])) + for icoeff in range(ncoeff): + outfile.write("%g " % bgridptr[igrid][ncols0+icoeff]) + outfile.write("\n") + igrid += 1 +outfile.close() + +# print out the Numpy array to a file + +outfile = open("bgrid_np.dat",'w') +for iz in range(ngridz): + for iy in range(ngridy): + for ix in range(ngridx): + outfile.write("x, y, z = %g %g %g\n" % + (bgridptr_np[iz][iy][ix][0], + bgridptr_np[iz][iy][ix][1], + bgridptr_np[iz][iy][ix][2])) + for icoeff in range(ncoeff): + outfile.write("%g " % bgridptr_np[iz][iy][ix][ncols0+icoeff]) + outfile.write("\n") +outfile.close() diff --git a/examples/snap/in.grid.python.local b/examples/snap/in.grid.python.local new file mode 100644 index 0000000000..af95696a2b --- /dev/null +++ b/examples/snap/in.grid.python.local @@ -0,0 +1,69 @@ +# Demonstrate bispectrum per-atom and grid computes + +# Invoked from grid.py +# pass in values for ngridx, ngridy, ngridz, twojmax + +# Initialize simulation + +variable nsteps equal 0 +variable nrep equal 1 +variable a equal 3.316 + +units metal + +# make processor grid equal to nz + +processors 1 1 ${ngridz} + +# generate the box and atom positions using a BCC lattice + +variable nx equal ${nrep} +variable ny equal ${nrep} +variable nz equal ${nrep} + +boundary p p p + +lattice custom ${a} a1 1 0 0 a2 0 1 0 a3 0 0 1 basis 0 0 0 basis 0.5 0.5 0.5 + +region box block 0 ${nx} 0 ${ny} 0 ${nz} +create_box 1 box +create_atoms 1 box + +mass 1 180.88 + +# define grid compute and atom compute + +group snapgroup type 1 +variable rcutfac equal 4.67637 +variable rfac0 equal 0.99363 +variable rmin0 equal 0 +variable wj equal 1 +variable radelem equal 0.5 +variable bzero equal 0 +variable quad equal 0 +variable switch equal 1 + +compute b all sna/atom ${rcutfac} ${rfac0} ${twojmax} ${radelem} ${wj} rmin0 ${rmin0} bzeroflag ${bzero} quadraticflag ${quad} switchflag ${switch} + +compute bgrid all sna/grid grid ${ngridx} ${ngridy} ${ngridz} ${rcutfac} ${rfac0} ${twojmax} ${radelem} ${wj} rmin0 ${rmin0} bzeroflag ${bzero} quadraticflag ${quad} switchflag ${switch} + +compute bgridlocal all sna/grid/local grid ${ngridx} ${ngridy} ${ngridz} ${rcutfac} ${rfac0} ${twojmax} ${radelem} ${wj} rmin0 ${rmin0} bzeroflag ${bzero} quadraticflag ${quad} switchflag ${switch} + +# create dummy potential for neighbor list + +variable rcutneigh equal 2.0*${rcutfac}*${radelem} +pair_style zero ${rcutneigh} +pair_coeff * * + +# define output + +thermo_style custom step temp ke pe vol c_bgrid[1][1] +thermo_modify norm yes + +dump mydump_b all custom 1000 dump_b id c_b[*] + +dump mydump_bgridlocal all local 1000 dump_bgridlocal index c_bgridlocal[*] + +# run + +run 0 From 2d2660487d6db0ed2599628c4613ce795d756c97 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Fri, 8 Apr 2022 15:23:17 -0600 Subject: [PATCH 103/585] flip signs for forces instead of gradients --- src/AMOEBA/amoeba_charge_transfer.cpp | 12 ++++----- src/AMOEBA/amoeba_dispersion.cpp | 18 +++++++------- src/AMOEBA/amoeba_hal.cpp | 36 +++++++++++++-------------- src/AMOEBA/amoeba_multipole.cpp | 19 +++++++------- src/AMOEBA/amoeba_polar.cpp | 36 +++++++++++++-------------- src/AMOEBA/angle_amoeba.cpp | 24 +++++++++--------- src/AMOEBA/fix_amoeba_bitorsion.cpp | 30 +++++++++++----------- src/AMOEBA/fix_amoeba_pitorsion.cpp | 36 +++++++++++++-------------- 8 files changed, 105 insertions(+), 106 deletions(-) diff --git a/src/AMOEBA/amoeba_charge_transfer.cpp b/src/AMOEBA/amoeba_charge_transfer.cpp index 5a7ee5b877..e68921f733 100644 --- a/src/AMOEBA/amoeba_charge_transfer.cpp +++ b/src/AMOEBA/amoeba_charge_transfer.cpp @@ -139,12 +139,12 @@ void PairAmoeba::charge_transfer() // increment the total charge transfer energy and derivatives - f[i][0] -= frcx; - f[i][1] -= frcy; - f[i][2] -= frcz; - f[j][0] += frcx; - f[j][1] += frcy; - f[j][2] += frcz; + f[i][0] += frcx; + f[i][1] += frcy; + f[i][2] += frcz; + f[j][0] -= frcx; + f[j][1] -= frcy; + f[j][2] -= frcz; // increment the internal virial tensor components diff --git a/src/AMOEBA/amoeba_dispersion.cpp b/src/AMOEBA/amoeba_dispersion.cpp index adda139ab0..d7d66e7f42 100644 --- a/src/AMOEBA/amoeba_dispersion.cpp +++ b/src/AMOEBA/amoeba_dispersion.cpp @@ -203,12 +203,12 @@ void PairAmoeba::dispersion_real() dedx = de * xr; dedy = de * yr; dedz = de * zr; - f[i][0] += dedx; - f[i][1] += dedy; - f[i][2] += dedz; - f[j][0] -= dedx; - f[j][1] -= dedy; - f[j][2] -= dedz; + f[i][0] -= dedx; + f[i][1] -= dedy; + f[i][2] -= dedz; + f[j][0] += dedx; + f[j][1] += dedy; + f[j][2] += dedz; // increment the internal virial tensor components @@ -407,9 +407,9 @@ void PairAmoeba::dispersion_kspace() } fi = csix[iclass]; - f[m][0] += fi * (recip[0][0]*de1 + recip[0][1]*de2 + recip[0][2]*de3); - f[m][1] += fi * (recip[1][0]*de1 + recip[1][1]*de2 + recip[1][2]*de3); - f[m][2] += fi * (recip[2][0]*de1 + recip[2][1]*de2 + recip[2][2]*de3); + f[m][0] -= fi * (recip[0][0]*de1 + recip[0][1]*de2 + recip[0][2]*de3); + f[m][1] -= fi * (recip[1][0]*de1 + recip[1][1]*de2 + recip[1][2]*de3); + f[m][2] -= fi * (recip[2][0]*de1 + recip[2][1]*de2 + recip[2][2]*de3); } // account for the energy and virial correction terms diff --git a/src/AMOEBA/amoeba_hal.cpp b/src/AMOEBA/amoeba_hal.cpp index 98cb3605b1..3dd7663528 100644 --- a/src/AMOEBA/amoeba_hal.cpp +++ b/src/AMOEBA/amoeba_hal.cpp @@ -159,31 +159,31 @@ void PairAmoeba::hal() "ghost comm is too short"); if (i == iv) { - f[i][0] += dedx; - f[i][1] += dedy; - f[i][2] += dedz; + f[i][0] -= dedx; + f[i][1] -= dedy; + f[i][2] -= dedz; } else { - f[i][0] += dedx*redi; - f[i][1] += dedy*redi; - f[i][2] += dedz*redi; - f[iv][0] += dedx*rediv; - f[iv][1] += dedy*rediv; - f[iv][2] += dedz*rediv; + f[i][0] -= dedx*redi; + f[i][1] -= dedy*redi; + f[i][2] -= dedz*redi; + f[iv][0] -= dedx*rediv; + f[iv][1] -= dedy*rediv; + f[iv][2] -= dedz*rediv; } if (j == jv) { - f[j][0] -= dedx; - f[j][1] -= dedy; - f[j][2] -= dedz; + f[j][0] += dedx; + f[j][1] += dedy; + f[j][2] += dedz; } else { redj = kred[jclass]; redjv = 1.0 - redj; - f[j][0] -= dedx*redj; - f[j][1] -= dedy*redj; - f[j][2] -= dedz*redj; - f[jv][0] -= dedx*redjv; - f[jv][1] -= dedy*redjv; - f[jv][2] -= dedz*redjv; + f[j][0] += dedx*redj; + f[j][1] += dedy*redj; + f[j][2] += dedz*redj; + f[jv][0] += dedx*redjv; + f[jv][1] += dedy*redjv; + f[jv][2] += dedz*redjv; } // increment the internal virial tensor components diff --git a/src/AMOEBA/amoeba_multipole.cpp b/src/AMOEBA/amoeba_multipole.cpp index 3e976acbf3..08403be1bd 100644 --- a/src/AMOEBA/amoeba_multipole.cpp +++ b/src/AMOEBA/amoeba_multipole.cpp @@ -509,18 +509,18 @@ void PairAmoeba::multipole_real() // increment force-based gradient and torque on first site - f[i][0] += frcx; - f[i][1] += frcy; - f[i][2] += frcz; + f[i][0] -= frcx; + f[i][1] -= frcy; + f[i][2] -= frcz; tq[i][0] += ttmi[0]; tq[i][1] += ttmi[1]; tq[i][2] += ttmi[2]; // increment force-based gradient and torque on second site - f[j][0] -= frcx; - f[j][1] -= frcy; - f[j][2] -= frcz; + f[j][0] += frcx; + f[j][1] += frcy; + f[j][2] += frcz; tq[j][0] += ttmk[0]; tq[j][1] += ttmk[1]; tq[j][2] += ttmk[2]; @@ -807,12 +807,11 @@ void PairAmoeba::multipole_kspace() h1 = recip[0][0]*f1 + recip[0][1]*f2 + recip[0][2]*f3; // matvec? h2 = recip[1][0]*f1 + recip[1][1]*f2 + recip[1][2]*f3; h3 = recip[2][0]*f1 + recip[2][1]*f2 + recip[2][2]*f3; - f[i][0] += h1; - f[i][1] += h2; - f[i][2] += h3; + f[i][0] -= h1; + f[i][1] -= h2; + f[i][2] -= h3; } empole += 0.5*e; - //printf("mpole_force %g %g %g \n", f[0][0], f[0][1], f[0][2]); // augment the permanent multipole virial contributions diff --git a/src/AMOEBA/amoeba_polar.cpp b/src/AMOEBA/amoeba_polar.cpp index cac2492df1..9c54852591 100644 --- a/src/AMOEBA/amoeba_polar.cpp +++ b/src/AMOEBA/amoeba_polar.cpp @@ -1140,12 +1140,12 @@ void PairAmoeba::polar_real() // increment force-based gradient on the interaction sites - f[i][0] -= frcx; - f[i][1] -= frcy; - f[i][2] -= frcz; - f[j][0] += frcx; - f[j][1] += frcy; - f[j][2] += frcz; + f[i][0] += frcx; + f[i][1] += frcy; + f[i][2] += frcz; + f[j][0] -= frcx; + f[j][1] -= frcy; + f[j][2] -= frcz; // increment the virial due to pairwise Cartesian forces @@ -1518,9 +1518,9 @@ void PairAmoeba::polar_kspace() h1 = recip[0][0]*f1 + recip[0][1]*f2 + recip[0][2]*f3; h2 = recip[1][0]*f1 + recip[1][1]*f2 + recip[1][2]*f3; h3 = recip[2][0]*f1 + recip[2][1]*f2 + recip[2][2]*f3; - f[i][0] += h1; - f[i][1] += h2; - f[i][2] += h3; + f[i][0] -= h1; + f[i][1] -= h2; + f[i][2] -= h3; } // set the potential to be the induced dipole average @@ -1672,9 +1672,9 @@ void PairAmoeba::polar_kspace() h2 = recip[1][0]*f1 + recip[1][1]*f2 + recip[1][2]*f3; h3 = recip[2][0]*f1 + recip[2][1]*f2 + recip[2][2]*f3; - f[i][0] += copm[k+m+1]*h1; - f[i][1] += copm[k+m+1]*h2; - f[i][2] += copm[k+m+1]*h3; + f[i][0] -= copm[k+m+1]*h1; + f[i][1] -= copm[k+m+1]*h2; + f[i][2] -= copm[k+m+1]*h3; for (j = 1; j < 4; j++) { cphid[j] = 0.0; @@ -1762,9 +1762,9 @@ void PairAmoeba::polar_kspace() h1 = recip[0][0]*f1 + recip[0][1]*f2 + recip[0][2]*f3; h2 = recip[1][0]*f1 + recip[1][1]*f2 + recip[1][2]*f3; h3 = recip[2][0]*f1 + recip[2][1]*f2 + recip[2][2]*f3; - f[i][0] += h1; - f[i][1] += h2; - f[i][2] += h3; + f[i][0] -= h1; + f[i][1] -= h2; + f[i][2] -= h3; for (j = 1; j < 4; j++) { cphid[j] = 0.0; @@ -1838,9 +1838,9 @@ void PairAmoeba::polar_kspace() h1 = recip[0][0]*f1 + recip[0][1]*f2 + recip[0][2]*f3; // matvec h2 = recip[1][0]*f1 + recip[1][1]*f2 + recip[1][2]*f3; h3 = recip[2][0]*f1 + recip[2][1]*f2 + recip[2][2]*f3; - f[i][0] += h1; - f[i][1] += h2; - f[i][2] += h3; + f[i][0] -= h1; + f[i][1] -= h2; + f[i][2] -= h3; for (j = 1; j < 4; j++) { cphid[j] = 0.0; diff --git a/src/AMOEBA/angle_amoeba.cpp b/src/AMOEBA/angle_amoeba.cpp index 216a79ff83..3ee7535c38 100644 --- a/src/AMOEBA/angle_amoeba.cpp +++ b/src/AMOEBA/angle_amoeba.cpp @@ -393,27 +393,27 @@ void AngleAmoeba::tinker_anglep(int i1, int i2, int i3, int type, int eflag) // apply force to each of 4 atoms if (newton_bond || i1 < nlocal) { - f[i1][0] += f1[0]; - f[i1][1] += f1[1]; - f[i1][2] += f1[2]; + f[i1][0] -= f1[0]; + f[i1][1] -= f1[1]; + f[i1][2] -= f1[2]; } if (newton_bond || i2 < nlocal) { - f[i2][0] += f2[0]; - f[i2][1] += f2[1]; - f[i2][2] += f2[2]; + f[i2][0] -= f2[0]; + f[i2][1] -= f2[1]; + f[i2][2] -= f2[2]; } if (newton_bond || i3 < nlocal) { - f[i3][0] += f3[0]; - f[i3][1] += f3[1]; - f[i3][2] += f3[2]; + f[i3][0] -= f3[0]; + f[i3][1] -= f3[1]; + f[i3][2] -= f3[2]; } if (newton_bond || i4 < nlocal) { - f[i4][0] += f4[0]; - f[i4][1] += f4[1]; - f[i4][2] += f4[2]; + f[i4][0] -= f4[0]; + f[i4][1] -= f4[1]; + f[i4][2] -= f4[2]; } if (evflag) ev_tally4(i1,i2,i3,14,nlocal,newton_bond,eangle,f1,f2,f3,f4); diff --git a/src/AMOEBA/fix_amoeba_bitorsion.cpp b/src/AMOEBA/fix_amoeba_bitorsion.cpp index 7a8c5253b6..b4d94a30f7 100644 --- a/src/AMOEBA/fix_amoeba_bitorsion.cpp +++ b/src/AMOEBA/fix_amoeba_bitorsion.cpp @@ -605,37 +605,37 @@ void FixAmoebaBiTorsion::post_force(int vflag) if (ia < nlocal) { ebitorsion += engfraction; - f[ia][0] += dedxia; - f[ia][1] += dedyia; - f[ia][2] += dedzia; + f[ia][0] -= dedxia; + f[ia][1] -= dedyia; + f[ia][2] -= dedzia; } if (ib < nlocal) { ebitorsion += engfraction; - f[ib][0] += dedxib + dedxib2; - f[ib][1] += dedyib + dedyib2; - f[ib][2] += dedzib + dedzib2; + f[ib][0] -= dedxib + dedxib2; + f[ib][1] -= dedyib + dedyib2; + f[ib][2] -= dedzib + dedzib2; } if (ic < nlocal) { ebitorsion += engfraction; - f[ic][0] += dedxic + dedxic2; - f[ic][1] += dedyic + dedyic2; - f[ic][2] += dedzic + dedzic2; + f[ic][0] -= dedxic + dedxic2; + f[ic][1] -= dedyic + dedyic2; + f[ic][2] -= dedzic + dedzic2; } if (id < nlocal) { ebitorsion += engfraction; - f[id][0] += dedxid + dedxid2; - f[id][1] += dedyid + dedyid2; - f[id][2] += dedzid + dedzid2; + f[id][0] -= dedxid + dedxid2; + f[id][1] -= dedyid + dedyid2; + f[id][2] -= dedzid + dedzid2; } if (ie < nlocal) { ebitorsion += engfraction; - f[ie][0] += dedxie2; - f[ie][1] += dedyie2; - f[ie][2] += dedzie2; + f[ie][0] -= dedxie2; + f[ie][1] -= dedyie2; + f[ie][2] -= dedzie2; } // increment the internal virial tensor components diff --git a/src/AMOEBA/fix_amoeba_pitorsion.cpp b/src/AMOEBA/fix_amoeba_pitorsion.cpp index 21f2f957ef..1d76f28faf 100644 --- a/src/AMOEBA/fix_amoeba_pitorsion.cpp +++ b/src/AMOEBA/fix_amoeba_pitorsion.cpp @@ -499,44 +499,44 @@ void FixAmoebaPiTorsion::post_force(int vflag) if (ia < nlocal) { epitorsion += engfraction; - f[ia][0] += dedxia; - f[ia][1] += dedyia; - f[ia][2] += dedzia; + f[ia][0] -= dedxia; + f[ia][1] -= dedyia; + f[ia][2] -= dedzia; } if (ib < nlocal) { epitorsion += engfraction; - f[ib][0] += dedxib; - f[ib][1] += dedyib; - f[ib][2] += dedzib; + f[ib][0] -= dedxib; + f[ib][1] -= dedyib; + f[ib][2] -= dedzib; } if (ic < nlocal) { epitorsion += engfraction; - f[ic][0] += dedxic; - f[ic][1] += dedyic; - f[ic][2] += dedzic; + f[ic][0] -= dedxic; + f[ic][1] -= dedyic; + f[ic][2] -= dedzic; } if (id < nlocal) { epitorsion += engfraction; - f[id][0] += dedxid; - f[id][1] += dedyid; - f[id][2] += dedzid; + f[id][0] -= dedxid; + f[id][1] -= dedyid; + f[id][2] -= dedzid; } if (ie < nlocal) { epitorsion += engfraction; - f[ie][0] += dedxie; - f[ie][1] += dedyie; - f[ie][2] += dedzie; + f[ie][0] -= dedxie; + f[ie][1] -= dedyie; + f[ie][2] -= dedzie; } if (ig < nlocal) { epitorsion += engfraction; - f[ig][0] += dedxig; - f[ig][1] += dedyig; - f[ig][2] += dedzig; + f[ig][0] -= dedxig; + f[ig][1] -= dedyig; + f[ig][2] -= dedzig; } // virial tensor components From 2111797ed873b29d4bf91caf7d81abd59cd6288b Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Fri, 8 Apr 2022 15:41:08 -0600 Subject: [PATCH 104/585] more force flips in torque2force --- src/AMOEBA/amoeba_utils.cpp | 36 ++++++++++++++++++------------------ 1 file changed, 18 insertions(+), 18 deletions(-) diff --git a/src/AMOEBA/amoeba_utils.cpp b/src/AMOEBA/amoeba_utils.cpp index ead7134ab6..0550e20bfb 100644 --- a/src/AMOEBA/amoeba_utils.cpp +++ b/src/AMOEBA/amoeba_utils.cpp @@ -1111,8 +1111,8 @@ void PairAmoeba::torque2force(int i, double *trq, if (axetyp == ZONLY) { for (j = 0; j < 3; j++) { du = uv[j]*dphidv/(usiz*uvsin) + uw[j]*dphidw/usiz; - f[ia][j] += du; - f[ib][j] -= du; + f[ia][j] -= du; + f[ib][j] += du; frcz[j] += du; } @@ -1122,9 +1122,9 @@ void PairAmoeba::torque2force(int i, double *trq, for (j = 0; j < 3; j++) { du = uv[j]*dphidv/(usiz*uvsin) + uw[j]*dphidw/usiz; dv = -uv[j]*dphidu/(vsiz*uvsin); - f[ia][j] += du; - f[ic][j] += dv; - f[ib][j] -= du + dv; + f[ia][j] -= du; + f[ic][j] -= dv; + f[ib][j] += du + dv; frcz[j] += du; frcx[j] += dv; } @@ -1135,9 +1135,9 @@ void PairAmoeba::torque2force(int i, double *trq, for (j = 0; j < 3; j++) { du = uv[j]*dphidv/(usiz*uvsin) + 0.5*uw[j]*dphidw/usiz; dv = -uv[j]*dphidu/(vsiz*uvsin) + 0.5*vw[j]*dphidw/vsiz; - f[ia][j] += du; - f[ic][j] += dv; - f[ib][j] -= du + dv; + f[ia][j] -= du; + f[ic][j] -= dv; + f[ib][j] += du + dv; frcz[j] += du; frcx[j] += dv; } @@ -1149,10 +1149,10 @@ void PairAmoeba::torque2force(int i, double *trq, du = ur[j]*dphidr/(usiz*ursin) + us[j]*dphids/usiz; dv = (vssin*s[j]-vscos*t1[j])*dphidu / (vsiz*(ut1sin+ut2sin)); dw = (wssin*s[j]-wscos*t2[j])*dphidu / (wsiz*(ut1sin+ut2sin)); - f[ia][j] += du; - f[ic][j] += dv; - f[id][j] += dw; - f[ib][j] -= du + dv + dw; + f[ia][j] -= du; + f[ic][j] -= dv; + f[id][j] -= dw; + f[ib][j] += du + dv + dw; frcz[j] += du; frcx[j] += dv; frcy[j] += dw; @@ -1191,8 +1191,8 @@ void PairAmoeba::torque2force(int i, double *trq, eps[2] = del[0]*w[1] - del[1]*w[0]; for (j = 0; j < 3; j++) { dw = del[j]*dphidr/(wsiz*rwsin) + eps[j]*dphiddel*wpcos/(wsiz*psiz); - f[id][j] += dw; - f[ib][j] -= dw; + f[id][j] -= dw; + f[ib][j] += dw; frcy[j] += dw; } r[0] = v[0] + w[0]; @@ -1216,8 +1216,8 @@ void PairAmoeba::torque2force(int i, double *trq, eps[2] = del[0]*u[1] - del[1]*u[0]; for (j = 0; j < 3; j++) { du = del[j]*dphidr/(usiz*rusin) + eps[j]*dphiddel*upcos/(usiz*psiz); - f[ia][j] += du; - f[ib][j] -= du; + f[ia][j] -= du; + f[ib][j] += du; frcz[j] += du; } r[0] = u[0] + w[0]; @@ -1241,8 +1241,8 @@ void PairAmoeba::torque2force(int i, double *trq, eps[2] = del[0]*v[1] - del[1]*v[0]; for (j = 0; j < 3; j++) { dv = del[j]*dphidr/(vsiz*rvsin) + eps[j]*dphiddel*vpcos/(vsiz*psiz); - f[ic][j] += dv; - f[ib][j] -= dv; + f[ic][j] -= dv; + f[ib][j] += dv; frcx[j] += dv; } } From da6fb4c5443d72e790484e63a23e3e9b4e272860 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Fri, 8 Apr 2022 15:47:12 -0600 Subject: [PATCH 105/585] Added epsilon shift to eliminate uneven tiebreaks --- src/compute_grid_local.cpp | 13 +++++++++++++ 1 file changed, 13 insertions(+) diff --git a/src/compute_grid_local.cpp b/src/compute_grid_local.cpp index 1b8de3c48a..e99a742c3b 100644 --- a/src/compute_grid_local.cpp +++ b/src/compute_grid_local.cpp @@ -191,6 +191,19 @@ void ComputeGridLocal::set_grid_local() zfrachi = comm->mysplit[2][1]; } + // not fully clear why this works + // without, sometimes get uneven assignments + // in case where ngridz is multiple of nprocz + + double MYEPS = 1.0e-10; + + xfraclo += MYEPS; + xfrachi += MYEPS; + yfraclo += MYEPS; + yfrachi += MYEPS; + zfraclo += MYEPS; + zfrachi += MYEPS; + nxlo = static_cast (xfraclo * nx); if (1.0*nxlo != xfraclo*nx) nxlo++; nxhi = static_cast (xfrachi * nx); From d0af0fa4569fd8369037d4c75c51df8845410c8e Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Fri, 8 Apr 2022 16:51:08 -0600 Subject: [PATCH 106/585] turn off terms for both amoeba and hippo --- examples/amoeba/in.water_dimer.amoeba | 10 +++++----- examples/amoeba/in.water_dimer.hippo | 10 +++++----- src/AMOEBA/amoeba_multipole.cpp | 1 + src/AMOEBA/angle_amoeba.cpp | 6 ++++-- src/AMOEBA/fix_amoeba_bitorsion.cpp | 6 ++++-- src/AMOEBA/fix_amoeba_pitorsion.cpp | 6 ++++-- src/AMOEBA/improper_amoeba.cpp | 21 ++++++++++++--------- src/CLASS2/bond_class2.cpp | 6 ++++-- src/EXTRA-MOLECULE/dihedral_fourier.cpp | 6 ++++-- tools/tinker/tinker2lmp.py | 3 ++- 10 files changed, 45 insertions(+), 30 deletions(-) diff --git a/examples/amoeba/in.water_dimer.amoeba b/examples/amoeba/in.water_dimer.amoeba index c0e6ee35e4..8c4a317643 100644 --- a/examples/amoeba/in.water_dimer.amoeba +++ b/examples/amoeba/in.water_dimer.amoeba @@ -21,7 +21,7 @@ read_data data.water_dimer.amoeba fix amtype NULL "Tinker Types" # force field -pair_style amoeba +pair_style amoeba include angle pair_coeff * * amoeba_water.prm amoeba_water.key special_bonds lj/coul 0.5 0.5 0.5 one/five yes @@ -35,10 +35,10 @@ thermo_style custom step temp epair ebond eangle edihed eimp & # zero step run -#run 0 +run 0 # dynamics -thermo 1 -fix 1 all nve -run 100 +#thermo 1 +#fix 1 all nve +#run 100 diff --git a/examples/amoeba/in.water_dimer.hippo b/examples/amoeba/in.water_dimer.hippo index 55b173b789..7401c21310 100644 --- a/examples/amoeba/in.water_dimer.hippo +++ b/examples/amoeba/in.water_dimer.hippo @@ -21,7 +21,7 @@ read_data data.water_dimer.hippo fix amtype NULL "Tinker Types" # force field -pair_style hippo +pair_style hippo include angle pair_coeff * * hippo_water.prm hippo_water.key special_bonds lj/coul 0.5 0.5 0.5 one/five yes @@ -35,10 +35,10 @@ thermo_style custom step temp epair ebond eangle edihed eimp & # zero step run -#run 0 +run 0 # dynamics -thermo 1 -fix 1 all nve -run 100 +#thermo 1 +#fix 1 all nve +#run 100 diff --git a/src/AMOEBA/amoeba_multipole.cpp b/src/AMOEBA/amoeba_multipole.cpp index 08403be1bd..748a1e799f 100644 --- a/src/AMOEBA/amoeba_multipole.cpp +++ b/src/AMOEBA/amoeba_multipole.cpp @@ -812,6 +812,7 @@ void PairAmoeba::multipole_kspace() f[i][2] -= h3; } empole += 0.5*e; + //printf("mpole_force %g %g %g \n", f[0][0], f[0][1], f[0][2]); // augment the permanent multipole virial contributions diff --git a/src/AMOEBA/angle_amoeba.cpp b/src/AMOEBA/angle_amoeba.cpp index 3ee7535c38..6b5bb93c02 100644 --- a/src/AMOEBA/angle_amoeba.cpp +++ b/src/AMOEBA/angle_amoeba.cpp @@ -697,9 +697,11 @@ void AngleAmoeba::coeff(int narg, char **arg) void AngleAmoeba::init_style() { - // check if PairAmoeba disabled angle or Urey-Bradley terms + // check if PairAmoeba or PairHippo disabled angle or Urey-Bradley terms - Pair *pair = force->pair_match("amoeba",1,0); + Pair *pair = NULL; + pair = force->pair_match("amoeba",1,0); + if (!pair) pair = force->pair_match("hippo",1,0); if (!pair) enable_angle = enable_urey = 1; else { diff --git a/src/AMOEBA/fix_amoeba_bitorsion.cpp b/src/AMOEBA/fix_amoeba_bitorsion.cpp index b4d94a30f7..28524df994 100644 --- a/src/AMOEBA/fix_amoeba_bitorsion.cpp +++ b/src/AMOEBA/fix_amoeba_bitorsion.cpp @@ -185,9 +185,11 @@ void FixAmoebaBiTorsion::init() if (respa_level >= 0) ilevel_respa = MIN(respa_level,ilevel_respa); } - // check if PairAmoeba disabled bitorsion terms + // check if PairAmoeba or PairHippo disabled bitorsion terms - Pair *pair = force->pair_match("amoeba",1,0); + Pair *pair = NULL; + pair = force->pair_match("amoeba",1,0); + if (!pair) pair = force->pair_match("hippo",1,0); if (!pair) disable = 0; else { diff --git a/src/AMOEBA/fix_amoeba_pitorsion.cpp b/src/AMOEBA/fix_amoeba_pitorsion.cpp index 1d76f28faf..f386c1b005 100644 --- a/src/AMOEBA/fix_amoeba_pitorsion.cpp +++ b/src/AMOEBA/fix_amoeba_pitorsion.cpp @@ -151,9 +151,11 @@ void FixAmoebaPiTorsion::init() if (respa_level >= 0) ilevel_respa = MIN(respa_level,ilevel_respa); } - // check if PairAmoeba disabled pitorsion terms + // check if PairAmoeba or PairHippo disabled pitorsion terms - Pair *pair = force->pair_match("amoeba",1,0); + Pair *pair = NULL; + pair = force->pair_match("amoeba",1,0); + if (!pair) pair = force->pair_match("hippo",1,0); if (!pair) disable = 0; else { diff --git a/src/AMOEBA/improper_amoeba.cpp b/src/AMOEBA/improper_amoeba.cpp index 93a9b412cd..d821c9411a 100644 --- a/src/AMOEBA/improper_amoeba.cpp +++ b/src/AMOEBA/improper_amoeba.cpp @@ -276,21 +276,24 @@ void ImproperAmoeba::coeff(int narg, char **arg) void ImproperAmoeba::init_style() { - Pair *pair = force->pair_match("amoeba",1,0); + // check if PairAmoeba disabled improper terms + + Pair *pair = NULL; + pair = force->pair_match("amoeba",1,0); if (!pair) pair = force->pair_match("hippo",1,0); - if (!pair) error->all(FLERR,"Improper amoeba could not find pair amoega"); - + if (!pair) error->all(FLERR,"Improper amoeba could not find pair amoeba/hippo"); + + int tmp; + int flag = *((int *) pair->extract("improper_flag",tmp)); + disable = flag ? 0 : 1; + + // also extract opbend params + int dim; opbend_cubic = *(double *) pair->extract("opbend_cubic",dim); opbend_quartic = *(double *) pair->extract("opbend_quartic",dim); opbend_pentic = *(double *) pair->extract("opbend_pentic",dim); opbend_sextic = *(double *) pair->extract("opbend_sextic",dim); - - // check if PairAmoeba disabled improper terms - - int tmp; - int flag = *((int *) pair->extract("improper_flag",tmp)); - disable = flag ? 0 : 1; } /* ---------------------------------------------------------------------- diff --git a/src/CLASS2/bond_class2.cpp b/src/CLASS2/bond_class2.cpp index d056b2aea9..79d1484768 100644 --- a/src/CLASS2/bond_class2.cpp +++ b/src/CLASS2/bond_class2.cpp @@ -161,9 +161,11 @@ void BondClass2::coeff(int narg, char **arg) void BondClass2::init_style() { - // check if PairAmoeba disabled bond terms + // check if PairAmoeba or PairHippo disabled bond terms - Pair *pair = force->pair_match("amoeba",1,0); + Pair *pair = NULL; + pair = force->pair_match("amoeba",1,0); + if (!pair) pair = force->pair_match("hippo",1,0); if (!pair) disable = 0; else { diff --git a/src/EXTRA-MOLECULE/dihedral_fourier.cpp b/src/EXTRA-MOLECULE/dihedral_fourier.cpp index 1dcbdf4563..72c79c3528 100644 --- a/src/EXTRA-MOLECULE/dihedral_fourier.cpp +++ b/src/EXTRA-MOLECULE/dihedral_fourier.cpp @@ -333,9 +333,11 @@ void DihedralFourier::coeff(int narg, char **arg) void DihedralFourier::init_style() { - // check if PairAmoeba disabled dihedral terms + // check if PairAmoeba or PairHippo disabled dihedral terms - Pair *pair = force->pair_match("amoeba",1,0); + Pair *pair = NULL; + pair = force->pair_match("amoeba",1,0); + if (!pair) pair = force->pair_match("hippo",1,0); if (!pair) disable = 0; else { diff --git a/tools/tinker/tinker2lmp.py b/tools/tinker/tinker2lmp.py index fec9f8a506..3d871747b6 100644 --- a/tools/tinker/tinker2lmp.py +++ b/tools/tinker/tinker2lmp.py @@ -860,12 +860,13 @@ for i,one in enumerate(alist): # IMPORTANT subtlety # flip order of 3 atoms in alist if the angle # matches Angle Bending section of PRM file in reverse order + # no need to flip if c1 = c3 # necessary b/c BondAngle coeffs will be generated with r1,r2 params # from Bond Stretching section of PRM file # since in general r1 != r2, the LAMMPS AngleAmoeba class requires # the 3 atoms in the angle be in the order that matches r1 and r2 - if (c3,c2,c1) in adict: + if c1 != c3 and (c3,c2,c1) in adict: m,params = adict[(c3,c2,c1)] alist[i] = (atom3,atom2,atom1) From 0e49bbe7106467df13a87d92d90806c554924f97 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Fri, 8 Apr 2022 17:16:12 -0600 Subject: [PATCH 107/585] recreate data files with different angle ordering method --- examples/amoeba/README | 25 + examples/amoeba/data.ubiquitin | 6496 ++++++++++----------- examples/amoeba/data.water_box.amoeba | 432 +- examples/amoeba/data.water_box.hippo | 432 +- examples/amoeba/data.water_dimer.amoeba | 4 +- examples/amoeba/data.water_dimer.hippo | 4 +- examples/amoeba/data.water_hexamer.amoeba | 12 +- examples/amoeba/data.water_hexamer.hippo | 12 +- examples/amoeba/in.water_box.amoeba | 8 +- examples/amoeba/in.water_box.hippo | 8 +- examples/amoeba/in.water_hexamer.amoeba | 8 +- examples/amoeba/in.water_hexamer.hippo | 8 +- 12 files changed, 3737 insertions(+), 3712 deletions(-) create mode 100644 examples/amoeba/README diff --git a/examples/amoeba/README b/examples/amoeba/README new file mode 100644 index 0000000000..57138357eb --- /dev/null +++ b/examples/amoeba/README @@ -0,0 +1,25 @@ +Data files in this directory were created by the tools/tinker/tinker2lmp.py script + +** water_dimer: + +% python tinker2lmp.py -xyz water_dimer.xyz -amoeba amoeba_water.prm -data data.water_dimer.amoeba + +% python tinker2lmp.py -xyz water_dimer.xyz -hippo hippo_water.prm -data data.water_dimer.hippo + +** water_hexamer: + +% python tinker2lmp.py -xyz water_hexamer.xyz -amoeba amoeba_water.prm -data data.water_hexamer.amoeba + +% python tinker2lmp.py -xyz water_hexamer.xyz -hippo hippo_water.prm -data data.water_hexamer.hippo + +** water_box: + +% python tinker2lmp.py -xyz water_box.xyz -amoeba amoeba_water.prm -data data.water_box.amoeba -pbc 18.643 18.643 18.643 + +% python tinker2lmp.py -xyz water_box.xyz -hippo hippo_water.prm -data data.water_box.hippo -pbc 18.643 18.643 18.643 + +** ubiquitin: + +% python tinker2lmp.py -xyz ubiquitin.xyz -amoeba amoeba_ubiquitin.prm -data data.ubiquitin.new -pbc 54.99 41.91 41.91 -bitorsion bitorsion.ubiquitin.data.new + + diff --git a/examples/amoeba/data.ubiquitin b/examples/amoeba/data.ubiquitin index 6b51695efb..aada520e6d 100644 --- a/examples/amoeba/data.ubiquitin +++ b/examples/amoeba/data.ubiquitin @@ -16682,9 +16682,9 @@ Angles 1 1 2 1 5 2 1 2 1 6 3 1 2 1 7 -4 2 6 1 5 -5 2 7 1 5 -6 2 7 1 6 +4 2 5 1 6 +5 2 5 1 7 +6 2 6 1 7 7 3 3 2 1 8 4 8 2 1 9 5 9 2 1 @@ -16699,20 +16699,20 @@ Angles 18 13 2 9 14 19 14 10 9 13 20 14 10 9 14 -21 15 14 9 13 +21 15 13 9 14 22 16 9 10 11 23 14 9 10 15 24 14 9 10 16 25 17 15 10 11 26 17 16 10 11 -27 15 16 10 15 -28 18 12 11 10 +27 15 15 10 16 +28 18 10 11 12 29 19 17 12 11 30 19 18 12 11 31 19 19 12 11 -32 15 18 12 17 -33 15 19 12 17 -34 15 19 12 18 +32 15 17 12 18 +33 15 17 12 19 +34 15 18 12 19 35 20 3 20 21 36 21 3 20 24 37 22 24 20 21 @@ -16730,19 +16730,19 @@ Angles 49 13 21 26 32 50 14 27 26 31 51 14 27 26 32 -52 15 32 26 31 +52 15 31 26 32 53 26 28 27 26 54 14 26 27 33 55 14 26 27 34 56 27 28 27 33 57 27 28 27 34 -58 15 34 27 33 +58 15 33 27 34 59 28 29 28 27 60 29 30 28 27 61 11 30 28 29 62 21 28 30 35 63 21 28 30 36 -64 30 36 30 35 +64 30 35 30 36 65 20 22 37 38 66 21 22 37 41 67 22 41 37 38 @@ -16758,7 +16758,7 @@ Angles 77 34 38 43 44 78 34 38 43 45 79 33 47 43 38 -80 35 45 43 44 +80 35 44 43 45 81 8 47 43 44 82 8 47 43 45 83 12 43 44 46 @@ -16766,19 +16766,19 @@ Angles 85 13 43 44 49 86 14 46 44 48 87 14 46 44 49 -88 15 49 44 48 +88 15 48 44 49 89 13 43 45 50 90 13 43 45 51 91 13 43 45 52 -92 15 51 45 50 -93 15 52 45 50 -94 15 52 45 51 +92 15 50 45 51 +93 15 50 45 52 +94 15 51 45 52 95 14 44 46 53 96 14 44 46 54 97 14 44 46 55 -98 15 54 46 53 -99 15 55 46 53 -100 15 55 46 54 +98 15 53 46 54 +99 15 53 46 55 +100 15 54 46 55 101 20 39 56 57 102 21 39 56 60 103 22 60 56 57 @@ -16796,23 +16796,23 @@ Angles 115 13 57 62 70 116 37 69 62 63 117 37 70 62 63 -118 15 70 62 69 +118 15 69 62 70 119 38 62 63 64 120 38 62 63 65 -121 39 65 63 64 -122 39 66 64 63 +121 39 64 63 65 +122 39 63 64 66 123 40 63 64 71 124 40 66 64 71 -125 39 67 65 63 +125 39 63 65 67 126 40 63 65 72 127 40 67 65 72 -128 39 68 66 64 +128 39 64 66 68 129 40 64 66 73 130 40 68 66 73 -131 39 68 67 65 +131 39 65 67 68 132 40 65 67 74 133 40 68 67 74 -134 39 67 68 66 +134 39 66 68 67 135 40 66 68 75 136 40 67 68 75 137 20 58 76 77 @@ -16830,21 +16830,21 @@ Angles 149 34 77 82 83 150 34 77 82 84 151 33 85 82 77 -152 35 84 82 83 +152 35 83 82 84 153 8 85 82 83 154 8 85 82 84 155 13 82 83 86 156 13 82 83 87 157 13 82 83 88 -158 15 87 83 86 -159 15 88 83 86 -160 15 88 83 87 +158 15 86 83 87 +159 15 86 83 88 +160 15 87 83 88 161 13 82 84 89 162 13 82 84 90 163 13 82 84 91 -164 15 90 84 89 -165 15 91 84 89 -166 15 91 84 90 +164 15 89 84 90 +165 15 89 84 91 +166 15 90 84 91 167 20 78 92 93 168 21 78 92 96 169 22 96 92 93 @@ -16862,31 +16862,31 @@ Angles 181 13 93 98 104 182 14 99 98 103 183 14 99 98 104 -184 15 104 98 103 -185 41 100 99 98 +184 15 103 98 104 +185 41 98 99 100 186 14 98 99 105 187 14 98 99 106 188 14 100 99 105 189 14 100 99 106 -190 15 106 99 105 -191 41 101 100 99 +190 15 105 99 106 +191 41 99 100 101 192 14 99 100 107 193 14 99 100 108 194 14 101 100 107 195 14 101 100 108 -196 15 108 100 107 +196 15 107 100 108 197 42 100 101 102 198 14 100 101 109 199 14 100 101 110 200 43 109 101 102 201 43 110 101 102 -202 15 110 101 109 +202 15 109 101 110 203 44 101 102 111 204 44 101 102 112 205 44 101 102 113 -206 45 112 102 111 -207 45 113 102 111 -208 45 113 102 112 +206 45 111 102 112 +207 45 111 102 113 +208 45 112 102 113 209 20 94 114 115 210 21 94 114 118 211 22 118 114 115 @@ -16909,9 +16909,9 @@ Angles 228 13 120 122 125 229 13 120 122 126 230 13 120 122 127 -231 15 126 122 125 -232 15 127 122 125 -233 15 127 122 126 +231 15 125 122 126 +232 15 125 122 127 +233 15 126 122 127 234 20 116 128 129 235 21 116 128 132 236 22 132 128 129 @@ -16924,30 +16924,30 @@ Angles 243 9 131 130 129 244 10 147 130 129 245 11 147 130 131 -246 50 135 134 129 +246 50 129 134 135 247 13 129 134 138 248 13 129 134 139 249 13 135 134 138 250 13 135 134 139 -251 15 139 134 138 -252 35 136 135 134 -253 35 137 135 134 +251 15 138 134 139 +252 35 134 135 136 +253 35 134 135 137 254 8 140 135 134 -255 35 137 135 136 +255 35 136 135 137 256 8 140 135 136 257 8 140 135 137 258 13 135 136 141 259 13 135 136 142 260 13 135 136 143 -261 15 142 136 141 -262 15 143 136 141 -263 15 143 136 142 +261 15 141 136 142 +262 15 141 136 143 +263 15 142 136 143 264 13 135 137 144 265 13 135 137 145 266 13 135 137 146 -267 15 145 137 144 -268 15 146 137 144 -269 15 146 137 145 +267 15 144 137 145 +268 15 144 137 146 +269 15 145 137 146 270 20 130 147 148 271 21 130 147 151 272 22 151 147 148 @@ -16970,9 +16970,9 @@ Angles 289 13 153 155 158 290 13 153 155 159 291 13 153 155 160 -292 15 159 155 158 -293 15 160 155 158 -294 15 160 155 159 +292 15 158 155 159 +293 15 158 155 160 +294 15 159 155 160 295 51 162 161 149 296 21 149 161 165 297 52 162 161 165 @@ -16981,7 +16981,7 @@ Angles 300 54 161 162 167 301 55 163 162 166 302 55 163 162 167 -303 56 167 162 166 +303 56 166 162 167 304 57 162 163 164 305 58 168 163 162 306 11 168 163 164 @@ -17002,31 +17002,31 @@ Angles 321 13 169 174 180 322 14 175 174 179 323 14 175 174 180 -324 15 180 174 179 -325 41 176 175 174 +324 15 179 174 180 +325 41 174 175 176 326 14 174 175 181 327 14 174 175 182 328 14 176 175 181 329 14 176 175 182 -330 15 182 175 181 -331 41 177 176 175 +330 15 181 175 182 +331 41 175 176 177 332 14 175 176 183 333 14 175 176 184 334 14 177 176 183 335 14 177 176 184 -336 15 184 176 183 +336 15 183 176 184 337 42 176 177 178 338 14 176 177 185 339 14 176 177 186 340 43 185 177 178 341 43 186 177 178 -342 15 186 177 185 +342 15 185 177 186 343 44 177 178 187 344 44 177 178 188 345 44 177 178 189 -346 45 188 178 187 -347 45 189 178 187 -348 45 189 178 188 +346 45 187 178 188 +347 45 187 178 189 +348 45 188 178 189 349 20 170 190 191 350 21 170 190 194 351 22 194 190 191 @@ -17049,9 +17049,9 @@ Angles 368 13 196 198 201 369 13 196 198 202 370 13 196 198 203 -371 15 202 198 201 -372 15 203 198 201 -373 15 203 198 202 +371 15 201 198 202 +372 15 201 198 203 +373 15 202 198 203 374 20 192 204 205 375 21 192 204 208 376 22 208 204 205 @@ -17067,7 +17067,7 @@ Angles 386 34 205 210 211 387 34 205 210 212 388 33 214 210 205 -389 35 212 210 211 +389 35 211 210 212 390 8 214 210 211 391 8 214 210 212 392 12 210 211 213 @@ -17075,19 +17075,19 @@ Angles 394 13 210 211 216 395 14 213 211 215 396 14 213 211 216 -397 15 216 211 215 +397 15 215 211 216 398 13 210 212 217 399 13 210 212 218 400 13 210 212 219 -401 15 218 212 217 -402 15 219 212 217 -403 15 219 212 218 +401 15 217 212 218 +402 15 217 212 219 +403 15 218 212 219 404 14 211 213 220 405 14 211 213 221 406 14 211 213 222 -407 15 221 213 220 -408 15 222 213 220 -409 15 222 213 221 +407 15 220 213 221 +408 15 220 213 222 +409 15 221 213 222 410 20 206 223 224 411 21 206 223 227 412 22 227 223 224 @@ -17110,9 +17110,9 @@ Angles 429 13 229 231 234 430 13 229 231 235 431 13 229 231 236 -432 15 235 231 234 -433 15 236 231 234 -434 15 236 231 235 +432 15 234 231 235 +433 15 234 231 236 +434 15 235 231 236 435 20 225 237 238 436 21 225 237 241 437 22 241 237 238 @@ -17125,30 +17125,30 @@ Angles 444 9 240 239 238 445 10 256 239 238 446 11 256 239 240 -447 50 244 243 238 +447 50 238 243 244 448 13 238 243 247 449 13 238 243 248 450 13 244 243 247 451 13 244 243 248 -452 15 248 243 247 -453 35 245 244 243 -454 35 246 244 243 +452 15 247 243 248 +453 35 243 244 245 +454 35 243 244 246 455 8 249 244 243 -456 35 246 244 245 +456 35 245 244 246 457 8 249 244 245 458 8 249 244 246 459 13 244 245 250 460 13 244 245 251 461 13 244 245 252 -462 15 251 245 250 -463 15 252 245 250 -464 15 252 245 251 +462 15 250 245 251 +463 15 250 245 252 +464 15 251 245 252 465 13 244 246 253 466 13 244 246 254 467 13 244 246 255 -468 15 254 246 253 -469 15 255 246 253 -470 15 255 246 254 +468 15 253 246 254 +469 15 253 246 255 +470 15 254 246 255 471 20 239 256 257 472 21 239 256 260 473 22 260 256 257 @@ -17166,16 +17166,16 @@ Angles 485 13 257 262 268 486 14 263 262 267 487 14 263 262 268 -488 15 268 262 267 +488 15 267 262 268 489 59 262 263 264 490 14 262 263 269 491 14 262 263 270 492 60 269 263 264 493 60 270 263 264 -494 15 270 263 269 +494 15 269 263 270 495 61 263 264 265 496 61 263 264 266 -497 62 266 264 265 +497 62 265 264 266 498 20 258 271 272 499 21 258 271 275 500 22 275 271 272 @@ -17191,21 +17191,21 @@ Angles 510 34 272 277 278 511 34 272 277 279 512 33 280 277 272 -513 35 279 277 278 +513 35 278 277 279 514 8 280 277 278 515 8 280 277 279 516 13 277 278 281 517 13 277 278 282 518 13 277 278 283 -519 15 282 278 281 -520 15 283 278 281 -521 15 283 278 282 +519 15 281 278 282 +520 15 281 278 283 +521 15 282 278 283 522 13 277 279 284 523 13 277 279 285 524 13 277 279 286 -525 15 285 279 284 -526 15 286 279 284 -527 15 286 279 285 +525 15 284 279 285 +526 15 284 279 286 +527 15 285 279 286 528 20 273 287 288 529 21 273 287 291 530 22 291 287 288 @@ -17223,16 +17223,16 @@ Angles 542 13 288 293 299 543 14 294 293 298 544 14 294 293 299 -545 15 299 293 298 +545 15 298 293 299 546 59 293 294 295 547 14 293 294 300 548 14 293 294 301 549 60 300 294 295 550 60 301 294 295 -551 15 301 294 300 +551 15 300 294 301 552 61 294 295 296 553 61 294 295 297 -554 62 297 295 296 +554 62 296 295 297 555 65 289 302 303 556 66 289 302 309 557 67 303 302 309 @@ -17250,19 +17250,19 @@ Angles 569 74 303 307 311 570 75 310 307 308 571 75 311 307 308 -572 76 311 307 310 -573 77 309 308 307 +572 76 310 307 311 +573 77 307 308 309 574 75 312 308 307 575 75 313 308 307 576 75 312 308 309 577 75 313 308 309 -578 76 313 308 312 +578 76 312 308 313 579 78 302 309 308 580 79 314 309 302 581 79 315 309 302 582 80 314 309 308 583 80 315 309 308 -584 81 315 309 314 +584 81 314 309 315 585 20 304 316 317 586 21 304 316 320 587 22 320 316 317 @@ -17280,7 +17280,7 @@ Angles 599 13 317 322 325 600 83 324 322 323 601 83 325 322 323 -602 15 325 322 324 +602 15 324 322 325 603 84 322 323 326 604 20 318 327 328 605 21 318 327 331 @@ -17299,10 +17299,10 @@ Angles 618 13 328 333 338 619 60 337 333 334 620 60 338 333 334 -621 15 338 333 337 +621 15 337 333 338 622 61 333 334 335 623 61 333 334 336 -624 62 336 334 335 +624 62 335 334 336 625 20 329 339 340 626 21 329 339 343 627 22 343 339 340 @@ -17325,9 +17325,9 @@ Angles 644 13 345 347 350 645 13 345 347 351 646 13 345 347 352 -647 15 351 347 350 -648 15 352 347 350 -649 15 352 347 351 +647 15 350 347 351 +648 15 350 347 352 +649 15 351 347 352 650 20 341 353 354 651 21 341 353 357 652 22 357 353 354 @@ -17343,7 +17343,7 @@ Angles 662 34 354 359 360 663 34 354 359 361 664 33 363 359 354 -665 35 361 359 360 +665 35 360 359 361 666 8 363 359 360 667 8 363 359 361 668 12 359 360 362 @@ -17351,19 +17351,19 @@ Angles 670 13 359 360 365 671 14 362 360 364 672 14 362 360 365 -673 15 365 360 364 +673 15 364 360 365 674 13 359 361 366 675 13 359 361 367 676 13 359 361 368 -677 15 367 361 366 -678 15 368 361 366 -679 15 368 361 367 +677 15 366 361 367 +678 15 366 361 368 +679 15 367 361 368 680 14 360 362 369 681 14 360 362 370 682 14 360 362 371 -683 15 370 362 369 -684 15 371 362 369 -685 15 371 362 370 +683 15 369 362 370 +684 15 369 362 371 +685 15 370 362 371 686 20 355 372 373 687 21 355 372 376 688 22 376 372 373 @@ -17381,16 +17381,16 @@ Angles 700 13 373 378 384 701 14 379 378 383 702 14 379 378 384 -703 15 384 378 383 +703 15 383 378 384 704 59 378 379 380 705 14 378 379 385 706 14 378 379 386 707 60 385 379 380 708 60 386 379 380 -709 15 386 379 385 +709 15 385 379 386 710 61 379 380 381 711 61 379 380 382 -712 62 382 380 381 +712 62 381 380 382 713 20 374 387 388 714 21 374 387 391 715 22 391 387 388 @@ -17408,13 +17408,13 @@ Angles 727 13 388 393 398 728 27 394 393 397 729 27 394 393 398 -730 15 398 393 397 +730 15 397 393 398 731 28 395 394 393 732 29 396 394 393 733 11 396 394 395 734 21 394 396 399 735 21 394 396 400 -736 30 400 396 399 +736 30 399 396 400 737 20 389 401 402 738 21 389 401 405 739 22 405 401 402 @@ -17430,21 +17430,21 @@ Angles 749 34 402 407 408 750 34 402 407 409 751 33 410 407 402 -752 35 409 407 408 +752 35 408 407 409 753 8 410 407 408 754 8 410 407 409 755 13 407 408 411 756 13 407 408 412 757 13 407 408 413 -758 15 412 408 411 -759 15 413 408 411 -760 15 413 408 412 +758 15 411 408 412 +759 15 411 408 413 +760 15 412 408 413 761 13 407 409 414 762 13 407 409 415 763 13 407 409 416 -764 15 415 409 414 -765 15 416 409 414 -766 15 416 409 415 +764 15 414 409 415 +765 15 414 409 416 +766 15 415 409 416 767 20 403 417 418 768 21 403 417 421 769 22 421 417 418 @@ -17462,31 +17462,31 @@ Angles 781 13 418 423 429 782 14 424 423 428 783 14 424 423 429 -784 15 429 423 428 -785 41 425 424 423 +784 15 428 423 429 +785 41 423 424 425 786 14 423 424 430 787 14 423 424 431 788 14 425 424 430 789 14 425 424 431 -790 15 431 424 430 -791 41 426 425 424 +790 15 430 424 431 +791 41 424 425 426 792 14 424 425 432 793 14 424 425 433 794 14 426 425 432 795 14 426 425 433 -796 15 433 425 432 +796 15 432 425 433 797 42 425 426 427 798 14 425 426 434 799 14 425 426 435 800 43 434 426 427 801 43 435 426 427 -802 15 435 426 434 +802 15 434 426 435 803 44 426 427 436 804 44 426 427 437 805 44 426 427 438 -806 45 437 427 436 -807 45 438 427 436 -808 45 438 427 437 +806 45 436 427 437 +807 45 436 427 438 +808 45 437 427 438 809 20 419 439 440 810 21 419 439 443 811 22 443 439 440 @@ -17502,9 +17502,9 @@ Angles 821 13 440 445 446 822 13 440 445 447 823 13 440 445 448 -824 15 447 445 446 -825 15 448 445 446 -826 15 448 445 447 +824 15 446 445 447 +825 15 446 445 448 +826 15 447 445 448 827 20 441 449 450 828 21 441 449 453 829 22 453 449 450 @@ -17522,31 +17522,31 @@ Angles 841 13 450 455 461 842 14 456 455 460 843 14 456 455 461 -844 15 461 455 460 -845 41 457 456 455 +844 15 460 455 461 +845 41 455 456 457 846 14 455 456 462 847 14 455 456 463 848 14 457 456 462 849 14 457 456 463 -850 15 463 456 462 -851 41 458 457 456 +850 15 462 456 463 +851 41 456 457 458 852 14 456 457 464 853 14 456 457 465 854 14 458 457 464 855 14 458 457 465 -856 15 465 457 464 +856 15 464 457 465 857 42 457 458 459 858 14 457 458 466 859 14 457 458 467 860 43 466 458 459 861 43 467 458 459 -862 15 467 458 466 +862 15 466 458 467 863 44 458 459 468 864 44 458 459 469 865 44 458 459 470 -866 45 469 459 468 -867 45 470 459 468 -868 45 470 459 469 +866 45 468 459 469 +867 45 468 459 470 +868 45 469 459 470 869 20 451 471 472 870 21 451 471 475 871 22 475 471 472 @@ -17562,7 +17562,7 @@ Angles 881 34 472 477 478 882 34 472 477 479 883 33 481 477 472 -884 35 479 477 478 +884 35 478 477 479 885 8 481 477 478 886 8 481 477 479 887 12 477 478 480 @@ -17570,19 +17570,19 @@ Angles 889 13 477 478 483 890 14 480 478 482 891 14 480 478 483 -892 15 483 478 482 +892 15 482 478 483 893 13 477 479 484 894 13 477 479 485 895 13 477 479 486 -896 15 485 479 484 -897 15 486 479 484 -898 15 486 479 485 +896 15 484 479 485 +897 15 484 479 486 +898 15 485 479 486 899 14 478 480 487 900 14 478 480 488 901 14 478 480 489 -902 15 488 480 487 -903 15 489 480 487 -904 15 489 480 488 +902 15 487 480 488 +903 15 487 480 489 +904 15 488 480 489 905 20 473 490 491 906 21 473 490 494 907 22 494 490 491 @@ -17600,19 +17600,19 @@ Angles 919 13 491 496 502 920 14 497 496 501 921 14 497 496 502 -922 15 502 496 501 +922 15 501 496 502 923 26 498 497 496 924 14 496 497 503 925 14 496 497 504 926 27 498 497 503 927 27 498 497 504 -928 15 504 497 503 +928 15 503 497 504 929 28 499 498 497 930 29 500 498 497 931 11 500 498 499 932 21 498 500 505 933 21 498 500 506 -934 30 506 500 505 +934 30 505 500 506 935 20 492 507 508 936 21 492 507 511 937 22 511 507 508 @@ -17630,10 +17630,10 @@ Angles 949 13 508 513 518 950 60 517 513 514 951 60 518 513 514 -952 15 518 513 517 +952 15 517 513 518 953 61 513 514 515 954 61 513 514 516 -955 62 516 514 515 +955 62 515 514 516 956 20 509 519 520 957 21 509 519 523 958 22 523 519 520 @@ -17651,31 +17651,31 @@ Angles 970 13 520 525 531 971 14 526 525 530 972 14 526 525 531 -973 15 531 525 530 -974 41 527 526 525 +973 15 530 525 531 +974 41 525 526 527 975 14 525 526 532 976 14 525 526 533 977 14 527 526 532 978 14 527 526 533 -979 15 533 526 532 -980 41 528 527 526 +979 15 532 526 533 +980 41 526 527 528 981 14 526 527 534 982 14 526 527 535 983 14 528 527 534 984 14 528 527 535 -985 15 535 527 534 +985 15 534 527 535 986 42 527 528 529 987 14 527 528 536 988 14 527 528 537 989 43 536 528 529 990 43 537 528 529 -991 15 537 528 536 +991 15 536 528 537 992 44 528 529 538 993 44 528 529 539 994 44 528 529 540 -995 45 539 529 538 -996 45 540 529 538 -997 45 540 529 539 +995 45 538 529 539 +996 45 538 529 540 +997 45 539 529 540 998 20 521 541 542 999 21 521 541 545 1000 22 545 541 542 @@ -17693,16 +17693,16 @@ Angles 1012 13 542 547 553 1013 14 548 547 552 1014 14 548 547 553 -1015 15 553 547 552 +1015 15 552 547 553 1016 59 547 548 549 1017 14 547 548 554 1018 14 547 548 555 1019 60 554 548 549 1020 60 555 548 549 -1021 15 555 548 554 +1021 15 554 548 555 1022 61 548 549 550 1023 61 548 549 551 -1024 62 551 549 550 +1024 62 550 549 551 1025 51 557 556 543 1026 21 543 556 560 1027 52 557 556 560 @@ -17711,7 +17711,7 @@ Angles 1030 54 556 557 562 1031 55 558 557 561 1032 55 558 557 562 -1033 56 562 557 561 +1033 56 561 557 562 1034 57 557 558 559 1035 58 563 558 557 1036 11 563 558 559 @@ -17730,7 +17730,7 @@ Angles 1049 34 564 569 570 1050 34 564 569 571 1051 33 573 569 564 -1052 35 571 569 570 +1052 35 570 569 571 1053 8 573 569 570 1054 8 573 569 571 1055 12 569 570 572 @@ -17738,19 +17738,19 @@ Angles 1057 13 569 570 575 1058 14 572 570 574 1059 14 572 570 575 -1060 15 575 570 574 +1060 15 574 570 575 1061 13 569 571 576 1062 13 569 571 577 1063 13 569 571 578 -1064 15 577 571 576 -1065 15 578 571 576 -1066 15 578 571 577 +1064 15 576 571 577 +1065 15 576 571 578 +1066 15 577 571 578 1067 14 570 572 579 1068 14 570 572 580 1069 14 570 572 581 -1070 15 580 572 579 -1071 15 581 572 579 -1072 15 581 572 580 +1070 15 579 572 580 +1071 15 579 572 581 +1072 15 580 572 581 1073 65 565 582 583 1074 66 565 582 589 1075 67 583 582 589 @@ -17768,19 +17768,19 @@ Angles 1087 74 583 587 591 1088 75 590 587 588 1089 75 591 587 588 -1090 76 591 587 590 -1091 77 589 588 587 +1090 76 590 587 591 +1091 77 587 588 589 1092 75 592 588 587 1093 75 593 588 587 1094 75 592 588 589 1095 75 593 588 589 -1096 76 593 588 592 +1096 76 592 588 593 1097 78 582 589 588 1098 79 594 589 582 1099 79 595 589 582 1100 80 594 589 588 1101 80 595 589 588 -1102 81 595 589 594 +1102 81 594 589 595 1103 65 584 596 597 1104 66 584 596 603 1105 67 597 596 603 @@ -17798,19 +17798,19 @@ Angles 1117 74 597 601 605 1118 75 604 601 602 1119 75 605 601 602 -1120 76 605 601 604 -1121 77 603 602 601 +1120 76 604 601 605 +1121 77 601 602 603 1122 75 606 602 601 1123 75 607 602 601 1124 75 606 602 603 1125 75 607 602 603 -1126 76 607 602 606 +1126 76 606 602 607 1127 78 596 603 602 1128 79 608 603 596 1129 79 609 603 596 1130 80 608 603 602 1131 80 609 603 602 -1132 81 609 603 608 +1132 81 608 603 609 1133 20 598 610 611 1134 21 598 610 614 1135 22 614 610 611 @@ -17828,10 +17828,10 @@ Angles 1147 13 611 616 621 1148 60 620 616 617 1149 60 621 616 617 -1150 15 621 616 620 +1150 15 620 616 621 1151 61 616 617 618 1152 61 616 617 619 -1153 62 619 617 618 +1153 62 618 617 619 1154 20 612 622 623 1155 21 612 622 626 1156 22 626 622 623 @@ -17849,19 +17849,19 @@ Angles 1168 13 623 628 634 1169 14 629 628 633 1170 14 629 628 634 -1171 15 634 628 633 +1171 15 633 628 634 1172 26 630 629 628 1173 14 628 629 635 1174 14 628 629 636 1175 27 630 629 635 1176 27 630 629 636 -1177 15 636 629 635 +1177 15 635 629 636 1178 28 631 630 629 1179 29 632 630 629 1180 11 632 630 631 1181 21 630 632 637 1182 21 630 632 638 -1183 30 638 632 637 +1183 30 637 632 638 1184 20 624 639 640 1185 21 624 639 643 1186 22 643 639 640 @@ -17879,19 +17879,19 @@ Angles 1198 13 640 645 651 1199 14 646 645 650 1200 14 646 645 651 -1201 15 651 645 650 +1201 15 650 645 651 1202 26 647 646 645 1203 14 645 646 652 1204 14 645 646 653 1205 27 647 646 652 1206 27 647 646 653 -1207 15 653 646 652 +1207 15 652 646 653 1208 28 648 647 646 1209 29 649 647 646 1210 11 649 647 648 1211 21 647 649 654 1212 21 647 649 655 -1213 30 655 649 654 +1213 30 654 649 655 1214 20 641 656 657 1215 21 641 656 660 1216 22 660 656 657 @@ -17909,31 +17909,31 @@ Angles 1228 13 657 662 670 1229 14 663 662 669 1230 14 663 662 670 -1231 15 670 662 669 -1232 41 664 663 662 +1231 15 669 662 670 +1232 41 662 663 664 1233 14 662 663 671 1234 14 662 663 672 1235 14 664 663 671 1236 14 664 663 672 -1237 15 672 663 671 +1237 15 671 663 672 1238 87 665 664 663 1239 14 663 664 673 1240 14 663 664 674 1241 88 665 664 673 1242 88 665 664 674 -1243 15 674 664 673 +1243 15 673 664 674 1244 89 664 665 666 1245 90 664 665 675 1246 91 675 665 666 -1247 92 667 666 665 -1248 92 668 666 665 -1249 92 668 666 667 +1247 92 665 666 667 +1248 92 665 666 668 +1249 92 667 666 668 1250 91 676 667 666 1251 91 677 667 666 -1252 93 677 667 676 +1252 93 676 667 677 1253 91 678 668 666 1254 91 679 668 666 -1255 93 679 668 678 +1255 93 678 668 679 1256 20 658 680 681 1257 21 658 680 684 1258 22 684 680 681 @@ -17946,30 +17946,30 @@ Angles 1265 9 683 682 681 1266 10 699 682 681 1267 11 699 682 683 -1268 50 687 686 681 +1268 50 681 686 687 1269 13 681 686 690 1270 13 681 686 691 1271 13 687 686 690 1272 13 687 686 691 -1273 15 691 686 690 -1274 35 688 687 686 -1275 35 689 687 686 +1273 15 690 686 691 +1274 35 686 687 688 +1275 35 686 687 689 1276 8 692 687 686 -1277 35 689 687 688 +1277 35 688 687 689 1278 8 692 687 688 1279 8 692 687 689 1280 13 687 688 693 1281 13 687 688 694 1282 13 687 688 695 -1283 15 694 688 693 -1284 15 695 688 693 -1285 15 695 688 694 +1283 15 693 688 694 +1284 15 693 688 695 +1285 15 694 688 695 1286 13 687 689 696 1287 13 687 689 697 1288 13 687 689 698 -1289 15 697 689 696 -1290 15 698 689 696 -1291 15 698 689 697 +1289 15 696 689 697 +1290 15 696 689 698 +1291 15 697 689 698 1292 20 682 699 700 1293 21 682 699 703 1294 22 703 699 700 @@ -17985,7 +17985,7 @@ Angles 1304 34 700 705 706 1305 34 700 705 707 1306 33 709 705 700 -1307 35 707 705 706 +1307 35 706 705 707 1308 8 709 705 706 1309 8 709 705 707 1310 12 705 706 708 @@ -17993,19 +17993,19 @@ Angles 1312 13 705 706 711 1313 14 708 706 710 1314 14 708 706 711 -1315 15 711 706 710 +1315 15 710 706 711 1316 13 705 707 712 1317 13 705 707 713 1318 13 705 707 714 -1319 15 713 707 712 -1320 15 714 707 712 -1321 15 714 707 713 +1319 15 712 707 713 +1320 15 712 707 714 +1321 15 713 707 714 1322 14 706 708 715 1323 14 706 708 716 1324 14 706 708 717 -1325 15 716 708 715 -1326 15 717 708 715 -1327 15 717 708 716 +1325 15 715 708 716 +1326 15 715 708 717 +1327 15 716 708 717 1328 20 701 718 719 1329 21 701 718 722 1330 22 722 718 719 @@ -18023,23 +18023,23 @@ Angles 1342 13 719 724 732 1343 37 731 724 725 1344 37 732 724 725 -1345 15 732 724 731 +1345 15 731 724 732 1346 38 724 725 726 1347 38 724 725 727 -1348 39 727 725 726 -1349 39 728 726 725 +1348 39 726 725 727 +1349 39 725 726 728 1350 40 725 726 733 1351 40 728 726 733 -1352 39 729 727 725 +1352 39 725 727 729 1353 40 725 727 734 1354 40 729 727 734 -1355 39 730 728 726 +1355 39 726 728 730 1356 40 726 728 735 1357 40 730 728 735 -1358 39 730 729 727 +1358 39 727 729 730 1359 40 727 729 736 1360 40 730 729 736 -1361 39 729 730 728 +1361 39 728 730 729 1362 40 728 730 737 1363 40 729 730 737 1364 20 720 738 739 @@ -18057,9 +18057,9 @@ Angles 1376 13 739 744 745 1377 13 739 744 746 1378 13 739 744 747 -1379 15 746 744 745 -1380 15 747 744 745 -1381 15 747 744 746 +1379 15 745 744 746 +1380 15 745 744 747 +1381 15 746 744 747 1382 51 749 748 740 1383 21 740 748 752 1384 52 749 748 752 @@ -18068,7 +18068,7 @@ Angles 1387 54 748 749 754 1388 55 750 749 753 1389 55 750 749 754 -1390 56 754 749 753 +1390 56 753 749 754 1391 57 749 750 751 1392 58 755 750 749 1393 11 755 750 751 @@ -18089,31 +18089,31 @@ Angles 1408 13 756 761 767 1409 14 762 761 766 1410 14 762 761 767 -1411 15 767 761 766 -1412 41 763 762 761 +1411 15 766 761 767 +1412 41 761 762 763 1413 14 761 762 768 1414 14 761 762 769 1415 14 763 762 768 1416 14 763 762 769 -1417 15 769 762 768 -1418 41 764 763 762 +1417 15 768 762 769 +1418 41 762 763 764 1419 14 762 763 770 1420 14 762 763 771 1421 14 764 763 770 1422 14 764 763 771 -1423 15 771 763 770 +1423 15 770 763 771 1424 42 763 764 765 1425 14 763 764 772 1426 14 763 764 773 1427 43 772 764 765 1428 43 773 764 765 -1429 15 773 764 772 +1429 15 772 764 773 1430 44 764 765 774 1431 44 764 765 775 1432 44 764 765 776 -1433 45 775 765 774 -1434 45 776 765 774 -1435 45 776 765 775 +1433 45 774 765 775 +1434 45 774 765 776 +1435 45 775 765 776 1436 20 757 777 778 1437 21 757 777 781 1438 22 781 777 778 @@ -18131,19 +18131,19 @@ Angles 1450 13 778 783 789 1451 14 784 783 788 1452 14 784 783 789 -1453 15 789 783 788 +1453 15 788 783 789 1454 26 785 784 783 1455 14 783 784 790 1456 14 783 784 791 1457 27 785 784 790 1458 27 785 784 791 -1459 15 791 784 790 +1459 15 790 784 791 1460 28 786 785 784 1461 29 787 785 784 1462 11 787 785 786 1463 21 785 787 792 1464 21 785 787 793 -1465 30 793 787 792 +1465 30 792 787 793 1466 20 779 794 795 1467 21 779 794 798 1468 22 798 794 795 @@ -18156,30 +18156,30 @@ Angles 1475 9 797 796 795 1476 10 813 796 795 1477 11 813 796 797 -1478 50 801 800 795 +1478 50 795 800 801 1479 13 795 800 804 1480 13 795 800 805 1481 13 801 800 804 1482 13 801 800 805 -1483 15 805 800 804 -1484 35 802 801 800 -1485 35 803 801 800 +1483 15 804 800 805 +1484 35 800 801 802 +1485 35 800 801 803 1486 8 806 801 800 -1487 35 803 801 802 +1487 35 802 801 803 1488 8 806 801 802 1489 8 806 801 803 1490 13 801 802 807 1491 13 801 802 808 1492 13 801 802 809 -1493 15 808 802 807 -1494 15 809 802 807 -1495 15 809 802 808 +1493 15 807 802 808 +1494 15 807 802 809 +1495 15 808 802 809 1496 13 801 803 810 1497 13 801 803 811 1498 13 801 803 812 -1499 15 811 803 810 -1500 15 812 803 810 -1501 15 812 803 811 +1499 15 810 803 811 +1500 15 810 803 812 +1501 15 811 803 812 1502 20 796 813 814 1503 21 796 813 817 1504 22 817 813 814 @@ -18197,16 +18197,16 @@ Angles 1516 13 814 819 825 1517 14 820 819 824 1518 14 820 819 825 -1519 15 825 819 824 +1519 15 824 819 825 1520 59 819 820 821 1521 14 819 820 826 1522 14 819 820 827 1523 60 826 820 821 1524 60 827 820 821 -1525 15 827 820 826 +1525 15 826 820 827 1526 61 820 821 822 1527 61 820 821 823 -1528 62 823 821 822 +1528 62 822 821 823 1529 20 815 828 829 1530 21 815 828 832 1531 22 832 828 829 @@ -18224,10 +18224,10 @@ Angles 1543 13 829 834 839 1544 60 838 834 835 1545 60 839 834 835 -1546 15 839 834 838 +1546 15 838 834 839 1547 61 834 835 836 1548 61 834 835 837 -1549 62 837 835 836 +1549 62 836 835 837 1550 51 841 840 830 1551 21 830 840 844 1552 52 841 840 844 @@ -18236,7 +18236,7 @@ Angles 1555 54 840 841 846 1556 55 842 841 845 1557 55 842 841 846 -1558 56 846 841 845 +1558 56 845 841 846 1559 57 841 842 843 1560 58 847 842 841 1561 11 847 842 843 @@ -18257,31 +18257,31 @@ Angles 1576 13 848 853 861 1577 14 854 853 860 1578 14 854 853 861 -1579 15 861 853 860 -1580 41 855 854 853 +1579 15 860 853 861 +1580 41 853 854 855 1581 14 853 854 862 1582 14 853 854 863 1583 14 855 854 862 1584 14 855 854 863 -1585 15 863 854 862 +1585 15 862 854 863 1586 87 856 855 854 1587 14 854 855 864 1588 14 854 855 865 1589 88 856 855 864 1590 88 856 855 865 -1591 15 865 855 864 +1591 15 864 855 865 1592 89 855 856 857 1593 90 855 856 866 1594 91 866 856 857 -1595 92 858 857 856 -1596 92 859 857 856 -1597 92 859 857 858 +1595 92 856 857 858 +1596 92 856 857 859 +1597 92 858 857 859 1598 91 867 858 857 1599 91 868 858 857 -1600 93 868 858 867 +1600 93 867 858 868 1601 91 869 859 857 1602 91 870 859 857 -1603 93 870 859 869 +1603 93 869 859 870 1604 20 849 871 872 1605 21 849 871 875 1606 22 875 871 872 @@ -18304,9 +18304,9 @@ Angles 1623 13 877 879 882 1624 13 877 879 883 1625 13 877 879 884 -1626 15 883 879 882 -1627 15 884 879 882 -1628 15 884 879 883 +1626 15 882 879 883 +1627 15 882 879 884 +1628 15 883 879 884 1629 20 873 885 886 1630 21 873 885 889 1631 22 889 885 886 @@ -18319,30 +18319,30 @@ Angles 1638 9 888 887 886 1639 10 904 887 886 1640 11 904 887 888 -1641 50 892 891 886 +1641 50 886 891 892 1642 13 886 891 895 1643 13 886 891 896 1644 13 892 891 895 1645 13 892 891 896 -1646 15 896 891 895 -1647 35 893 892 891 -1648 35 894 892 891 +1646 15 895 891 896 +1647 35 891 892 893 +1648 35 891 892 894 1649 8 897 892 891 -1650 35 894 892 893 +1650 35 893 892 894 1651 8 897 892 893 1652 8 897 892 894 1653 13 892 893 898 1654 13 892 893 899 1655 13 892 893 900 -1656 15 899 893 898 -1657 15 900 893 898 -1658 15 900 893 899 +1656 15 898 893 899 +1657 15 898 893 900 +1658 15 899 893 900 1659 13 892 894 901 1660 13 892 894 902 1661 13 892 894 903 -1662 15 902 894 901 -1663 15 903 894 901 -1664 15 903 894 902 +1662 15 901 894 902 +1663 15 901 894 903 +1664 15 902 894 903 1665 20 887 904 905 1666 21 887 904 908 1667 22 908 904 905 @@ -18360,7 +18360,7 @@ Angles 1679 13 905 910 913 1680 83 912 910 911 1681 83 913 910 911 -1682 15 913 910 912 +1682 15 912 910 913 1683 84 910 911 914 1684 20 906 915 916 1685 21 906 915 919 @@ -18379,10 +18379,10 @@ Angles 1698 13 916 921 926 1699 60 925 921 922 1700 60 926 921 922 -1701 15 926 921 925 +1701 15 925 921 926 1702 61 921 922 923 1703 61 921 922 924 -1704 62 924 922 923 +1704 62 923 922 924 1705 20 917 927 928 1706 21 917 927 931 1707 22 931 927 928 @@ -18400,23 +18400,23 @@ Angles 1719 13 928 933 942 1720 37 941 933 934 1721 37 942 933 934 -1722 15 942 933 941 +1722 15 941 933 942 1723 38 933 934 935 1724 38 933 934 936 -1725 39 936 934 935 -1726 39 937 935 934 +1725 39 935 934 936 +1726 39 934 935 937 1727 40 934 935 943 1728 40 937 935 943 -1729 39 938 936 934 +1729 39 934 936 938 1730 40 934 936 944 1731 40 938 936 944 -1732 39 939 937 935 +1732 39 935 937 939 1733 40 935 937 945 1734 40 939 937 945 -1735 39 939 938 936 +1735 39 936 938 939 1736 40 936 938 946 1737 40 939 938 946 -1738 39 938 939 937 +1738 39 937 939 938 1739 94 937 939 940 1740 94 938 939 940 1741 95 939 940 947 @@ -18437,13 +18437,13 @@ Angles 1756 13 949 954 959 1757 27 955 954 958 1758 27 955 954 959 -1759 15 959 954 958 +1759 15 958 954 959 1760 28 956 955 954 1761 29 957 955 954 1762 11 957 955 956 1763 21 955 957 960 1764 21 955 957 961 -1765 30 961 957 960 +1765 30 960 957 961 1766 20 950 962 963 1767 21 950 962 966 1768 22 966 962 963 @@ -18459,7 +18459,7 @@ Angles 1778 34 963 968 969 1779 34 963 968 970 1780 33 972 968 963 -1781 35 970 968 969 +1781 35 969 968 970 1782 8 972 968 969 1783 8 972 968 970 1784 12 968 969 971 @@ -18467,19 +18467,19 @@ Angles 1786 13 968 969 974 1787 14 971 969 973 1788 14 971 969 974 -1789 15 974 969 973 +1789 15 973 969 974 1790 13 968 970 975 1791 13 968 970 976 1792 13 968 970 977 -1793 15 976 970 975 -1794 15 977 970 975 -1795 15 977 970 976 +1793 15 975 970 976 +1794 15 975 970 977 +1795 15 976 970 977 1796 14 969 971 978 1797 14 969 971 979 1798 14 969 971 980 -1799 15 979 971 978 -1800 15 980 971 978 -1801 15 980 971 979 +1799 15 978 971 979 +1800 15 978 971 980 +1801 15 979 971 980 1802 20 964 981 982 1803 21 964 981 985 1804 22 985 981 982 @@ -18497,19 +18497,19 @@ Angles 1816 13 982 987 993 1817 14 988 987 992 1818 14 988 987 993 -1819 15 993 987 992 +1819 15 992 987 993 1820 26 989 988 987 1821 14 987 988 994 1822 14 987 988 995 1823 27 989 988 994 1824 27 989 988 995 -1825 15 995 988 994 +1825 15 994 988 995 1826 28 990 989 988 1827 29 991 989 988 1828 11 991 989 990 1829 21 989 991 996 1830 21 989 991 997 -1831 30 997 991 996 +1831 30 996 991 997 1832 20 983 998 999 1833 21 983 998 1002 1834 22 1002 998 999 @@ -18527,31 +18527,31 @@ Angles 1846 13 999 1004 1010 1847 14 1005 1004 1009 1848 14 1005 1004 1010 -1849 15 1010 1004 1009 -1850 41 1006 1005 1004 +1849 15 1009 1004 1010 +1850 41 1004 1005 1006 1851 14 1004 1005 1011 1852 14 1004 1005 1012 1853 14 1006 1005 1011 1854 14 1006 1005 1012 -1855 15 1012 1005 1011 -1856 41 1007 1006 1005 +1855 15 1011 1005 1012 +1856 41 1005 1006 1007 1857 14 1005 1006 1013 1858 14 1005 1006 1014 1859 14 1007 1006 1013 1860 14 1007 1006 1014 -1861 15 1014 1006 1013 +1861 15 1013 1006 1014 1862 42 1006 1007 1008 1863 14 1006 1007 1015 1864 14 1006 1007 1016 1865 43 1015 1007 1008 1866 43 1016 1007 1008 -1867 15 1016 1007 1015 +1867 15 1015 1007 1016 1868 44 1007 1008 1017 1869 44 1007 1008 1018 1870 44 1007 1008 1019 -1871 45 1018 1008 1017 -1872 45 1019 1008 1017 -1873 45 1019 1008 1018 +1871 45 1017 1008 1018 +1872 45 1017 1008 1019 +1873 45 1018 1008 1019 1874 20 1000 1020 1021 1875 21 1000 1020 1024 1876 22 1024 1020 1021 @@ -18569,16 +18569,16 @@ Angles 1888 13 1021 1026 1032 1889 14 1027 1026 1031 1890 14 1027 1026 1032 -1891 15 1032 1026 1031 +1891 15 1031 1026 1032 1892 59 1026 1027 1028 1893 14 1026 1027 1033 1894 14 1026 1027 1034 1895 60 1033 1027 1028 1896 60 1034 1027 1028 -1897 15 1034 1027 1033 +1897 15 1033 1027 1034 1898 61 1027 1028 1029 1899 61 1027 1028 1030 -1900 62 1030 1028 1029 +1900 62 1029 1028 1030 1901 20 1022 1035 1036 1902 21 1022 1035 1039 1903 22 1039 1035 1036 @@ -18596,7 +18596,7 @@ Angles 1915 13 1036 1041 1044 1916 83 1043 1041 1042 1917 83 1044 1041 1042 -1918 15 1044 1041 1043 +1918 15 1043 1041 1044 1919 84 1041 1042 1045 1920 20 1037 1046 1047 1921 21 1037 1046 1050 @@ -18620,9 +18620,9 @@ Angles 1939 13 1052 1054 1057 1940 13 1052 1054 1058 1941 13 1052 1054 1059 -1942 15 1058 1054 1057 -1943 15 1059 1054 1057 -1944 15 1059 1054 1058 +1942 15 1057 1054 1058 +1943 15 1057 1054 1059 +1944 15 1058 1054 1059 1945 20 1048 1060 1061 1946 21 1048 1060 1064 1947 22 1064 1060 1061 @@ -18635,30 +18635,30 @@ Angles 1954 9 1063 1062 1061 1955 10 1079 1062 1061 1956 11 1079 1062 1063 -1957 50 1067 1066 1061 +1957 50 1061 1066 1067 1958 13 1061 1066 1070 1959 13 1061 1066 1071 1960 13 1067 1066 1070 1961 13 1067 1066 1071 -1962 15 1071 1066 1070 -1963 35 1068 1067 1066 -1964 35 1069 1067 1066 +1962 15 1070 1066 1071 +1963 35 1066 1067 1068 +1964 35 1066 1067 1069 1965 8 1072 1067 1066 -1966 35 1069 1067 1068 +1966 35 1068 1067 1069 1967 8 1072 1067 1068 1968 8 1072 1067 1069 1969 13 1067 1068 1073 1970 13 1067 1068 1074 1971 13 1067 1068 1075 -1972 15 1074 1068 1073 -1973 15 1075 1068 1073 -1974 15 1075 1068 1074 +1972 15 1073 1068 1074 +1973 15 1073 1068 1075 +1974 15 1074 1068 1075 1975 13 1067 1069 1076 1976 13 1067 1069 1077 1977 13 1067 1069 1078 -1978 15 1077 1069 1076 -1979 15 1078 1069 1076 -1980 15 1078 1069 1077 +1978 15 1076 1069 1077 +1979 15 1076 1069 1078 +1980 15 1077 1069 1078 1981 20 1062 1079 1080 1982 21 1062 1079 1083 1983 22 1083 1079 1080 @@ -18676,7 +18676,7 @@ Angles 1995 13 1080 1085 1092 1996 97 1091 1085 1086 1997 97 1092 1085 1086 -1998 15 1092 1085 1091 +1998 15 1091 1085 1092 1999 98 1085 1086 1087 2000 99 1085 1086 1088 2001 100 1087 1086 1088 @@ -18686,7 +18686,7 @@ Angles 2005 100 1090 1088 1086 2006 104 1086 1088 1094 2007 105 1090 1088 1094 -2008 106 1090 1089 1087 +2008 106 1087 1089 1090 2009 107 1087 1089 1095 2010 107 1090 1089 1095 2011 101 1088 1090 1089 @@ -18704,30 +18704,30 @@ Angles 2023 9 1100 1099 1098 2024 10 1116 1099 1098 2025 11 1116 1099 1100 -2026 50 1104 1103 1098 +2026 50 1098 1103 1104 2027 13 1098 1103 1107 2028 13 1098 1103 1108 2029 13 1104 1103 1107 2030 13 1104 1103 1108 -2031 15 1108 1103 1107 -2032 35 1105 1104 1103 -2033 35 1106 1104 1103 +2031 15 1107 1103 1108 +2032 35 1103 1104 1105 +2033 35 1103 1104 1106 2034 8 1109 1104 1103 -2035 35 1106 1104 1105 +2035 35 1105 1104 1106 2036 8 1109 1104 1105 2037 8 1109 1104 1106 2038 13 1104 1105 1110 2039 13 1104 1105 1111 2040 13 1104 1105 1112 -2041 15 1111 1105 1110 -2042 15 1112 1105 1110 -2043 15 1112 1105 1111 +2041 15 1110 1105 1111 +2042 15 1110 1105 1112 +2043 15 1111 1105 1112 2044 13 1104 1106 1113 2045 13 1104 1106 1114 2046 13 1104 1106 1115 -2047 15 1114 1106 1113 -2048 15 1115 1106 1113 -2049 15 1115 1106 1114 +2047 15 1113 1106 1114 +2048 15 1113 1106 1115 +2049 15 1114 1106 1115 2050 20 1099 1116 1117 2051 21 1099 1116 1120 2052 22 1120 1116 1117 @@ -18743,21 +18743,21 @@ Angles 2062 34 1117 1122 1123 2063 34 1117 1122 1124 2064 33 1125 1122 1117 -2065 35 1124 1122 1123 +2065 35 1123 1122 1124 2066 8 1125 1122 1123 2067 8 1125 1122 1124 2068 13 1122 1123 1126 2069 13 1122 1123 1127 2070 13 1122 1123 1128 -2071 15 1127 1123 1126 -2072 15 1128 1123 1126 -2073 15 1128 1123 1127 +2071 15 1126 1123 1127 +2072 15 1126 1123 1128 +2073 15 1127 1123 1128 2074 13 1122 1124 1129 2075 13 1122 1124 1130 2076 13 1122 1124 1131 -2077 15 1130 1124 1129 -2078 15 1131 1124 1129 -2079 15 1131 1124 1130 +2077 15 1129 1124 1130 +2078 15 1129 1124 1131 +2079 15 1130 1124 1131 2080 20 1118 1132 1133 2081 21 1118 1132 1136 2082 22 1136 1132 1133 @@ -18770,30 +18770,30 @@ Angles 2089 9 1135 1134 1133 2090 10 1151 1134 1133 2091 11 1151 1134 1135 -2092 50 1139 1138 1133 +2092 50 1133 1138 1139 2093 13 1133 1138 1142 2094 13 1133 1138 1143 2095 13 1139 1138 1142 2096 13 1139 1138 1143 -2097 15 1143 1138 1142 -2098 35 1140 1139 1138 -2099 35 1141 1139 1138 +2097 15 1142 1138 1143 +2098 35 1138 1139 1140 +2099 35 1138 1139 1141 2100 8 1144 1139 1138 -2101 35 1141 1139 1140 +2101 35 1140 1139 1141 2102 8 1144 1139 1140 2103 8 1144 1139 1141 2104 13 1139 1140 1145 2105 13 1139 1140 1146 2106 13 1139 1140 1147 -2107 15 1146 1140 1145 -2108 15 1147 1140 1145 -2109 15 1147 1140 1146 +2107 15 1145 1140 1146 +2108 15 1145 1140 1147 +2109 15 1146 1140 1147 2110 13 1139 1141 1148 2111 13 1139 1141 1149 2112 13 1139 1141 1150 -2113 15 1149 1141 1148 -2114 15 1150 1141 1148 -2115 15 1150 1141 1149 +2113 15 1148 1141 1149 +2114 15 1148 1141 1150 +2115 15 1149 1141 1150 2116 20 1134 1151 1152 2117 21 1134 1151 1155 2118 22 1155 1151 1152 @@ -18811,31 +18811,31 @@ Angles 2130 13 1152 1157 1165 2131 14 1158 1157 1164 2132 14 1158 1157 1165 -2133 15 1165 1157 1164 -2134 41 1159 1158 1157 +2133 15 1164 1157 1165 +2134 41 1157 1158 1159 2135 14 1157 1158 1166 2136 14 1157 1158 1167 2137 14 1159 1158 1166 2138 14 1159 1158 1167 -2139 15 1167 1158 1166 +2139 15 1166 1158 1167 2140 87 1160 1159 1158 2141 14 1158 1159 1168 2142 14 1158 1159 1169 2143 88 1160 1159 1168 2144 88 1160 1159 1169 -2145 15 1169 1159 1168 +2145 15 1168 1159 1169 2146 89 1159 1160 1161 2147 90 1159 1160 1170 2148 91 1170 1160 1161 -2149 92 1162 1161 1160 -2150 92 1163 1161 1160 -2151 92 1163 1161 1162 +2149 92 1160 1161 1162 +2150 92 1160 1161 1163 +2151 92 1162 1161 1163 2152 91 1171 1162 1161 2153 91 1172 1162 1161 -2154 93 1172 1162 1171 +2154 93 1171 1162 1172 2155 91 1173 1163 1161 2156 91 1174 1163 1161 -2157 93 1174 1163 1173 +2157 93 1173 1163 1174 2158 20 1153 1175 1176 2159 21 1153 1175 1179 2160 22 1179 1175 1176 @@ -18848,30 +18848,30 @@ Angles 2167 9 1178 1177 1176 2168 10 1194 1177 1176 2169 11 1194 1177 1178 -2170 50 1182 1181 1176 +2170 50 1176 1181 1182 2171 13 1176 1181 1185 2172 13 1176 1181 1186 2173 13 1182 1181 1185 2174 13 1182 1181 1186 -2175 15 1186 1181 1185 -2176 35 1183 1182 1181 -2177 35 1184 1182 1181 +2175 15 1185 1181 1186 +2176 35 1181 1182 1183 +2177 35 1181 1182 1184 2178 8 1187 1182 1181 -2179 35 1184 1182 1183 +2179 35 1183 1182 1184 2180 8 1187 1182 1183 2181 8 1187 1182 1184 2182 13 1182 1183 1188 2183 13 1182 1183 1189 2184 13 1182 1183 1190 -2185 15 1189 1183 1188 -2186 15 1190 1183 1188 -2187 15 1190 1183 1189 +2185 15 1188 1183 1189 +2186 15 1188 1183 1190 +2187 15 1189 1183 1190 2188 13 1182 1184 1191 2189 13 1182 1184 1192 2190 13 1182 1184 1193 -2191 15 1192 1184 1191 -2192 15 1193 1184 1191 -2193 15 1193 1184 1192 +2191 15 1191 1184 1192 +2192 15 1191 1184 1193 +2193 15 1192 1184 1193 2194 20 1177 1194 1195 2195 21 1177 1194 1198 2196 22 1198 1194 1195 @@ -18889,31 +18889,31 @@ Angles 2208 13 1195 1200 1208 2209 14 1201 1200 1207 2210 14 1201 1200 1208 -2211 15 1208 1200 1207 -2212 41 1202 1201 1200 +2211 15 1207 1200 1208 +2212 41 1200 1201 1202 2213 14 1200 1201 1209 2214 14 1200 1201 1210 2215 14 1202 1201 1209 2216 14 1202 1201 1210 -2217 15 1210 1201 1209 +2217 15 1209 1201 1210 2218 87 1203 1202 1201 2219 14 1201 1202 1211 2220 14 1201 1202 1212 2221 88 1203 1202 1211 2222 88 1203 1202 1212 -2223 15 1212 1202 1211 +2223 15 1211 1202 1212 2224 89 1202 1203 1204 2225 90 1202 1203 1213 2226 91 1213 1203 1204 -2227 92 1205 1204 1203 -2228 92 1206 1204 1203 -2229 92 1206 1204 1205 +2227 92 1203 1204 1205 +2228 92 1203 1204 1206 +2229 92 1205 1204 1206 2230 91 1214 1205 1204 2231 91 1215 1205 1204 -2232 93 1215 1205 1214 +2232 93 1214 1205 1215 2233 91 1216 1206 1204 2234 91 1217 1206 1204 -2235 93 1217 1206 1216 +2235 93 1216 1206 1217 2236 51 1219 1218 1196 2237 21 1196 1218 1222 2238 52 1219 1218 1222 @@ -18922,7 +18922,7 @@ Angles 2241 54 1218 1219 1224 2242 55 1220 1219 1223 2243 55 1220 1219 1224 -2244 56 1224 1219 1223 +2244 56 1223 1219 1224 2245 57 1219 1220 1221 2246 58 1225 1220 1219 2247 11 1225 1220 1221 @@ -18934,2845 +18934,2845 @@ Angles 2253 54 1225 1226 1231 2254 109 1230 1226 1227 2255 109 1231 1226 1227 -2256 56 1231 1226 1230 +2256 56 1230 1226 1231 2257 110 1226 1227 1228 2258 110 1226 1227 1232 -2259 62 1232 1227 1228 -2260 111 1235 1233 1234 -2261 111 1238 1236 1237 -2262 111 1241 1239 1240 -2263 111 1244 1242 1243 -2264 111 1247 1245 1246 -2265 111 1250 1248 1249 -2266 111 1253 1251 1252 -2267 111 1256 1254 1255 -2268 111 1259 1257 1258 -2269 111 1262 1260 1261 -2270 111 1265 1263 1264 -2271 111 1268 1266 1267 -2272 111 1271 1269 1270 -2273 111 1274 1272 1273 -2274 111 1277 1275 1276 -2275 111 1280 1278 1279 -2276 111 1283 1281 1282 -2277 111 1286 1284 1285 -2278 111 1289 1287 1288 -2279 111 1292 1290 1291 -2280 111 1295 1293 1294 -2281 111 1298 1296 1297 -2282 111 1301 1299 1300 -2283 111 1304 1302 1303 -2284 111 1307 1305 1306 -2285 111 1310 1308 1309 -2286 111 1313 1311 1312 -2287 111 1316 1314 1315 -2288 111 1319 1317 1318 -2289 111 1322 1320 1321 -2290 111 1325 1323 1324 -2291 111 1328 1326 1327 -2292 111 1331 1329 1330 -2293 111 1334 1332 1333 -2294 111 1337 1335 1336 -2295 111 1340 1338 1339 -2296 111 1343 1341 1342 -2297 111 1346 1344 1345 -2298 111 1349 1347 1348 -2299 111 1352 1350 1351 -2300 111 1355 1353 1354 -2301 111 1358 1356 1357 -2302 111 1361 1359 1360 -2303 111 1364 1362 1363 -2304 111 1367 1365 1366 -2305 111 1370 1368 1369 -2306 111 1373 1371 1372 -2307 111 1376 1374 1375 -2308 111 1379 1377 1378 -2309 111 1382 1380 1381 -2310 111 1385 1383 1384 -2311 111 1388 1386 1387 -2312 111 1391 1389 1390 -2313 111 1394 1392 1393 -2314 111 1397 1395 1396 -2315 111 1400 1398 1399 -2316 111 1403 1401 1402 -2317 111 1406 1404 1405 -2318 111 1409 1407 1408 -2319 111 1412 1410 1411 -2320 111 1415 1413 1414 -2321 111 1418 1416 1417 -2322 111 1421 1419 1420 -2323 111 1424 1422 1423 -2324 111 1427 1425 1426 -2325 111 1430 1428 1429 -2326 111 1433 1431 1432 -2327 111 1436 1434 1435 -2328 111 1439 1437 1438 -2329 111 1442 1440 1441 -2330 111 1445 1443 1444 -2331 111 1448 1446 1447 -2332 111 1451 1449 1450 -2333 111 1454 1452 1453 -2334 111 1457 1455 1456 -2335 111 1460 1458 1459 -2336 111 1463 1461 1462 -2337 111 1466 1464 1465 -2338 111 1469 1467 1468 -2339 111 1472 1470 1471 -2340 111 1475 1473 1474 -2341 111 1478 1476 1477 -2342 111 1481 1479 1480 -2343 111 1484 1482 1483 -2344 111 1487 1485 1486 -2345 111 1490 1488 1489 -2346 111 1493 1491 1492 -2347 111 1496 1494 1495 -2348 111 1499 1497 1498 -2349 111 1502 1500 1501 -2350 111 1505 1503 1504 -2351 111 1508 1506 1507 -2352 111 1511 1509 1510 -2353 111 1514 1512 1513 -2354 111 1517 1515 1516 -2355 111 1520 1518 1519 -2356 111 1523 1521 1522 -2357 111 1526 1524 1525 -2358 111 1529 1527 1528 -2359 111 1532 1530 1531 -2360 111 1535 1533 1534 -2361 111 1538 1536 1537 -2362 111 1541 1539 1540 -2363 111 1544 1542 1543 -2364 111 1547 1545 1546 -2365 111 1550 1548 1549 -2366 111 1553 1551 1552 -2367 111 1556 1554 1555 -2368 111 1559 1557 1558 -2369 111 1562 1560 1561 -2370 111 1565 1563 1564 -2371 111 1568 1566 1567 -2372 111 1571 1569 1570 -2373 111 1574 1572 1573 -2374 111 1577 1575 1576 -2375 111 1580 1578 1579 -2376 111 1583 1581 1582 -2377 111 1586 1584 1585 -2378 111 1589 1587 1588 -2379 111 1592 1590 1591 -2380 111 1595 1593 1594 -2381 111 1598 1596 1597 -2382 111 1601 1599 1600 -2383 111 1604 1602 1603 -2384 111 1607 1605 1606 -2385 111 1610 1608 1609 -2386 111 1613 1611 1612 -2387 111 1616 1614 1615 -2388 111 1619 1617 1618 -2389 111 1622 1620 1621 -2390 111 1625 1623 1624 -2391 111 1628 1626 1627 -2392 111 1631 1629 1630 -2393 111 1634 1632 1633 -2394 111 1637 1635 1636 -2395 111 1640 1638 1639 -2396 111 1643 1641 1642 -2397 111 1646 1644 1645 -2398 111 1649 1647 1648 -2399 111 1652 1650 1651 -2400 111 1655 1653 1654 -2401 111 1658 1656 1657 -2402 111 1661 1659 1660 -2403 111 1664 1662 1663 -2404 111 1667 1665 1666 -2405 111 1670 1668 1669 -2406 111 1673 1671 1672 -2407 111 1676 1674 1675 -2408 111 1679 1677 1678 -2409 111 1682 1680 1681 -2410 111 1685 1683 1684 -2411 111 1688 1686 1687 -2412 111 1691 1689 1690 -2413 111 1694 1692 1693 -2414 111 1697 1695 1696 -2415 111 1700 1698 1699 -2416 111 1703 1701 1702 -2417 111 1706 1704 1705 -2418 111 1709 1707 1708 -2419 111 1712 1710 1711 -2420 111 1715 1713 1714 -2421 111 1718 1716 1717 -2422 111 1721 1719 1720 -2423 111 1724 1722 1723 -2424 111 1727 1725 1726 -2425 111 1730 1728 1729 -2426 111 1733 1731 1732 -2427 111 1736 1734 1735 -2428 111 1739 1737 1738 -2429 111 1742 1740 1741 -2430 111 1745 1743 1744 -2431 111 1748 1746 1747 -2432 111 1751 1749 1750 -2433 111 1754 1752 1753 -2434 111 1757 1755 1756 -2435 111 1760 1758 1759 -2436 111 1763 1761 1762 -2437 111 1766 1764 1765 -2438 111 1769 1767 1768 -2439 111 1772 1770 1771 -2440 111 1775 1773 1774 -2441 111 1778 1776 1777 -2442 111 1781 1779 1780 -2443 111 1784 1782 1783 -2444 111 1787 1785 1786 -2445 111 1790 1788 1789 -2446 111 1793 1791 1792 -2447 111 1796 1794 1795 -2448 111 1799 1797 1798 -2449 111 1802 1800 1801 -2450 111 1805 1803 1804 -2451 111 1808 1806 1807 -2452 111 1811 1809 1810 -2453 111 1814 1812 1813 -2454 111 1817 1815 1816 -2455 111 1820 1818 1819 -2456 111 1823 1821 1822 -2457 111 1826 1824 1825 -2458 111 1829 1827 1828 -2459 111 1832 1830 1831 -2460 111 1835 1833 1834 -2461 111 1838 1836 1837 -2462 111 1841 1839 1840 -2463 111 1844 1842 1843 -2464 111 1847 1845 1846 -2465 111 1850 1848 1849 -2466 111 1853 1851 1852 -2467 111 1856 1854 1855 -2468 111 1859 1857 1858 -2469 111 1862 1860 1861 -2470 111 1865 1863 1864 -2471 111 1868 1866 1867 -2472 111 1871 1869 1870 -2473 111 1874 1872 1873 -2474 111 1877 1875 1876 -2475 111 1880 1878 1879 -2476 111 1883 1881 1882 -2477 111 1886 1884 1885 -2478 111 1889 1887 1888 -2479 111 1892 1890 1891 -2480 111 1895 1893 1894 -2481 111 1898 1896 1897 -2482 111 1901 1899 1900 -2483 111 1904 1902 1903 -2484 111 1907 1905 1906 -2485 111 1910 1908 1909 -2486 111 1913 1911 1912 -2487 111 1916 1914 1915 -2488 111 1919 1917 1918 -2489 111 1922 1920 1921 -2490 111 1925 1923 1924 -2491 111 1928 1926 1927 -2492 111 1931 1929 1930 -2493 111 1934 1932 1933 -2494 111 1937 1935 1936 -2495 111 1940 1938 1939 -2496 111 1943 1941 1942 -2497 111 1946 1944 1945 -2498 111 1949 1947 1948 -2499 111 1952 1950 1951 -2500 111 1955 1953 1954 -2501 111 1958 1956 1957 -2502 111 1961 1959 1960 -2503 111 1964 1962 1963 -2504 111 1967 1965 1966 -2505 111 1970 1968 1969 -2506 111 1973 1971 1972 -2507 111 1976 1974 1975 -2508 111 1979 1977 1978 -2509 111 1982 1980 1981 -2510 111 1985 1983 1984 -2511 111 1988 1986 1987 -2512 111 1991 1989 1990 -2513 111 1994 1992 1993 -2514 111 1997 1995 1996 -2515 111 2000 1998 1999 -2516 111 2003 2001 2002 -2517 111 2006 2004 2005 -2518 111 2009 2007 2008 -2519 111 2012 2010 2011 -2520 111 2015 2013 2014 -2521 111 2018 2016 2017 -2522 111 2021 2019 2020 -2523 111 2024 2022 2023 -2524 111 2027 2025 2026 -2525 111 2030 2028 2029 -2526 111 2033 2031 2032 -2527 111 2036 2034 2035 -2528 111 2039 2037 2038 -2529 111 2042 2040 2041 -2530 111 2045 2043 2044 -2531 111 2048 2046 2047 -2532 111 2051 2049 2050 -2533 111 2054 2052 2053 -2534 111 2057 2055 2056 -2535 111 2060 2058 2059 -2536 111 2063 2061 2062 -2537 111 2066 2064 2065 -2538 111 2069 2067 2068 -2539 111 2072 2070 2071 -2540 111 2075 2073 2074 -2541 111 2078 2076 2077 -2542 111 2081 2079 2080 -2543 111 2084 2082 2083 -2544 111 2087 2085 2086 -2545 111 2090 2088 2089 -2546 111 2093 2091 2092 -2547 111 2096 2094 2095 -2548 111 2099 2097 2098 -2549 111 2102 2100 2101 -2550 111 2105 2103 2104 -2551 111 2108 2106 2107 -2552 111 2111 2109 2110 -2553 111 2114 2112 2113 -2554 111 2117 2115 2116 -2555 111 2120 2118 2119 -2556 111 2123 2121 2122 -2557 111 2126 2124 2125 -2558 111 2129 2127 2128 -2559 111 2132 2130 2131 -2560 111 2135 2133 2134 -2561 111 2138 2136 2137 -2562 111 2141 2139 2140 -2563 111 2144 2142 2143 -2564 111 2147 2145 2146 -2565 111 2150 2148 2149 -2566 111 2153 2151 2152 -2567 111 2156 2154 2155 -2568 111 2159 2157 2158 -2569 111 2162 2160 2161 -2570 111 2165 2163 2164 -2571 111 2168 2166 2167 -2572 111 2171 2169 2170 -2573 111 2174 2172 2173 -2574 111 2177 2175 2176 -2575 111 2180 2178 2179 -2576 111 2183 2181 2182 -2577 111 2186 2184 2185 -2578 111 2189 2187 2188 -2579 111 2192 2190 2191 -2580 111 2195 2193 2194 -2581 111 2198 2196 2197 -2582 111 2201 2199 2200 -2583 111 2204 2202 2203 -2584 111 2207 2205 2206 -2585 111 2210 2208 2209 -2586 111 2213 2211 2212 -2587 111 2216 2214 2215 -2588 111 2219 2217 2218 -2589 111 2222 2220 2221 -2590 111 2225 2223 2224 -2591 111 2228 2226 2227 -2592 111 2231 2229 2230 -2593 111 2234 2232 2233 -2594 111 2237 2235 2236 -2595 111 2240 2238 2239 -2596 111 2243 2241 2242 -2597 111 2246 2244 2245 -2598 111 2249 2247 2248 -2599 111 2252 2250 2251 -2600 111 2255 2253 2254 -2601 111 2258 2256 2257 -2602 111 2261 2259 2260 -2603 111 2264 2262 2263 -2604 111 2267 2265 2266 -2605 111 2270 2268 2269 -2606 111 2273 2271 2272 -2607 111 2276 2274 2275 -2608 111 2279 2277 2278 -2609 111 2282 2280 2281 -2610 111 2285 2283 2284 -2611 111 2288 2286 2287 -2612 111 2291 2289 2290 -2613 111 2294 2292 2293 -2614 111 2297 2295 2296 -2615 111 2300 2298 2299 -2616 111 2303 2301 2302 -2617 111 2306 2304 2305 -2618 111 2309 2307 2308 -2619 111 2312 2310 2311 -2620 111 2315 2313 2314 -2621 111 2318 2316 2317 -2622 111 2321 2319 2320 -2623 111 2324 2322 2323 -2624 111 2327 2325 2326 -2625 111 2330 2328 2329 -2626 111 2333 2331 2332 -2627 111 2336 2334 2335 -2628 111 2339 2337 2338 -2629 111 2342 2340 2341 -2630 111 2345 2343 2344 -2631 111 2348 2346 2347 -2632 111 2351 2349 2350 -2633 111 2354 2352 2353 -2634 111 2357 2355 2356 -2635 111 2360 2358 2359 -2636 111 2363 2361 2362 -2637 111 2366 2364 2365 -2638 111 2369 2367 2368 -2639 111 2372 2370 2371 -2640 111 2375 2373 2374 -2641 111 2378 2376 2377 -2642 111 2381 2379 2380 -2643 111 2384 2382 2383 -2644 111 2387 2385 2386 -2645 111 2390 2388 2389 -2646 111 2393 2391 2392 -2647 111 2396 2394 2395 -2648 111 2399 2397 2398 -2649 111 2402 2400 2401 -2650 111 2405 2403 2404 -2651 111 2408 2406 2407 -2652 111 2411 2409 2410 -2653 111 2414 2412 2413 -2654 111 2417 2415 2416 -2655 111 2420 2418 2419 -2656 111 2423 2421 2422 -2657 111 2426 2424 2425 -2658 111 2429 2427 2428 -2659 111 2432 2430 2431 -2660 111 2435 2433 2434 -2661 111 2438 2436 2437 -2662 111 2441 2439 2440 -2663 111 2444 2442 2443 -2664 111 2447 2445 2446 -2665 111 2450 2448 2449 -2666 111 2453 2451 2452 -2667 111 2456 2454 2455 -2668 111 2459 2457 2458 -2669 111 2462 2460 2461 -2670 111 2465 2463 2464 -2671 111 2468 2466 2467 -2672 111 2471 2469 2470 -2673 111 2474 2472 2473 -2674 111 2477 2475 2476 -2675 111 2480 2478 2479 -2676 111 2483 2481 2482 -2677 111 2486 2484 2485 -2678 111 2489 2487 2488 -2679 111 2492 2490 2491 -2680 111 2495 2493 2494 -2681 111 2498 2496 2497 -2682 111 2501 2499 2500 -2683 111 2504 2502 2503 -2684 111 2507 2505 2506 -2685 111 2510 2508 2509 -2686 111 2513 2511 2512 -2687 111 2516 2514 2515 -2688 111 2519 2517 2518 -2689 111 2522 2520 2521 -2690 111 2525 2523 2524 -2691 111 2528 2526 2527 -2692 111 2531 2529 2530 -2693 111 2534 2532 2533 -2694 111 2537 2535 2536 -2695 111 2540 2538 2539 -2696 111 2543 2541 2542 -2697 111 2546 2544 2545 -2698 111 2549 2547 2548 -2699 111 2552 2550 2551 -2700 111 2555 2553 2554 -2701 111 2558 2556 2557 -2702 111 2561 2559 2560 -2703 111 2564 2562 2563 -2704 111 2567 2565 2566 -2705 111 2570 2568 2569 -2706 111 2573 2571 2572 -2707 111 2576 2574 2575 -2708 111 2579 2577 2578 -2709 111 2582 2580 2581 -2710 111 2585 2583 2584 -2711 111 2588 2586 2587 -2712 111 2591 2589 2590 -2713 111 2594 2592 2593 -2714 111 2597 2595 2596 -2715 111 2600 2598 2599 -2716 111 2603 2601 2602 -2717 111 2606 2604 2605 -2718 111 2609 2607 2608 -2719 111 2612 2610 2611 -2720 111 2615 2613 2614 -2721 111 2618 2616 2617 -2722 111 2621 2619 2620 -2723 111 2624 2622 2623 -2724 111 2627 2625 2626 -2725 111 2630 2628 2629 -2726 111 2633 2631 2632 -2727 111 2636 2634 2635 -2728 111 2639 2637 2638 -2729 111 2642 2640 2641 -2730 111 2645 2643 2644 -2731 111 2648 2646 2647 -2732 111 2651 2649 2650 -2733 111 2654 2652 2653 -2734 111 2657 2655 2656 -2735 111 2660 2658 2659 -2736 111 2663 2661 2662 -2737 111 2666 2664 2665 -2738 111 2669 2667 2668 -2739 111 2672 2670 2671 -2740 111 2675 2673 2674 -2741 111 2678 2676 2677 -2742 111 2681 2679 2680 -2743 111 2684 2682 2683 -2744 111 2687 2685 2686 -2745 111 2690 2688 2689 -2746 111 2693 2691 2692 -2747 111 2696 2694 2695 -2748 111 2699 2697 2698 -2749 111 2702 2700 2701 -2750 111 2705 2703 2704 -2751 111 2708 2706 2707 -2752 111 2711 2709 2710 -2753 111 2714 2712 2713 -2754 111 2717 2715 2716 -2755 111 2720 2718 2719 -2756 111 2723 2721 2722 -2757 111 2726 2724 2725 -2758 111 2729 2727 2728 -2759 111 2732 2730 2731 -2760 111 2735 2733 2734 -2761 111 2738 2736 2737 -2762 111 2741 2739 2740 -2763 111 2744 2742 2743 -2764 111 2747 2745 2746 -2765 111 2750 2748 2749 -2766 111 2753 2751 2752 -2767 111 2756 2754 2755 -2768 111 2759 2757 2758 -2769 111 2762 2760 2761 -2770 111 2765 2763 2764 -2771 111 2768 2766 2767 -2772 111 2771 2769 2770 -2773 111 2774 2772 2773 -2774 111 2777 2775 2776 -2775 111 2780 2778 2779 -2776 111 2783 2781 2782 -2777 111 2786 2784 2785 -2778 111 2789 2787 2788 -2779 111 2792 2790 2791 -2780 111 2795 2793 2794 -2781 111 2798 2796 2797 -2782 111 2801 2799 2800 -2783 111 2804 2802 2803 -2784 111 2807 2805 2806 -2785 111 2810 2808 2809 -2786 111 2813 2811 2812 -2787 111 2816 2814 2815 -2788 111 2819 2817 2818 -2789 111 2822 2820 2821 -2790 111 2825 2823 2824 -2791 111 2828 2826 2827 -2792 111 2831 2829 2830 -2793 111 2834 2832 2833 -2794 111 2837 2835 2836 -2795 111 2840 2838 2839 -2796 111 2843 2841 2842 -2797 111 2846 2844 2845 -2798 111 2849 2847 2848 -2799 111 2852 2850 2851 -2800 111 2855 2853 2854 -2801 111 2858 2856 2857 -2802 111 2861 2859 2860 -2803 111 2864 2862 2863 -2804 111 2867 2865 2866 -2805 111 2870 2868 2869 -2806 111 2873 2871 2872 -2807 111 2876 2874 2875 -2808 111 2879 2877 2878 -2809 111 2882 2880 2881 -2810 111 2885 2883 2884 -2811 111 2888 2886 2887 -2812 111 2891 2889 2890 -2813 111 2894 2892 2893 -2814 111 2897 2895 2896 -2815 111 2900 2898 2899 -2816 111 2903 2901 2902 -2817 111 2906 2904 2905 -2818 111 2909 2907 2908 -2819 111 2912 2910 2911 -2820 111 2915 2913 2914 -2821 111 2918 2916 2917 -2822 111 2921 2919 2920 -2823 111 2924 2922 2923 -2824 111 2927 2925 2926 -2825 111 2930 2928 2929 -2826 111 2933 2931 2932 -2827 111 2936 2934 2935 -2828 111 2939 2937 2938 -2829 111 2942 2940 2941 -2830 111 2945 2943 2944 -2831 111 2948 2946 2947 -2832 111 2951 2949 2950 -2833 111 2954 2952 2953 -2834 111 2957 2955 2956 -2835 111 2960 2958 2959 -2836 111 2963 2961 2962 -2837 111 2966 2964 2965 -2838 111 2969 2967 2968 -2839 111 2972 2970 2971 -2840 111 2975 2973 2974 -2841 111 2978 2976 2977 -2842 111 2981 2979 2980 -2843 111 2984 2982 2983 -2844 111 2987 2985 2986 -2845 111 2990 2988 2989 -2846 111 2993 2991 2992 -2847 111 2996 2994 2995 -2848 111 2999 2997 2998 -2849 111 3002 3000 3001 -2850 111 3005 3003 3004 -2851 111 3008 3006 3007 -2852 111 3011 3009 3010 -2853 111 3014 3012 3013 -2854 111 3017 3015 3016 -2855 111 3020 3018 3019 -2856 111 3023 3021 3022 -2857 111 3026 3024 3025 -2858 111 3029 3027 3028 -2859 111 3032 3030 3031 -2860 111 3035 3033 3034 -2861 111 3038 3036 3037 -2862 111 3041 3039 3040 -2863 111 3044 3042 3043 -2864 111 3047 3045 3046 -2865 111 3050 3048 3049 -2866 111 3053 3051 3052 -2867 111 3056 3054 3055 -2868 111 3059 3057 3058 -2869 111 3062 3060 3061 -2870 111 3065 3063 3064 -2871 111 3068 3066 3067 -2872 111 3071 3069 3070 -2873 111 3074 3072 3073 -2874 111 3077 3075 3076 -2875 111 3080 3078 3079 -2876 111 3083 3081 3082 -2877 111 3086 3084 3085 -2878 111 3089 3087 3088 -2879 111 3092 3090 3091 -2880 111 3095 3093 3094 -2881 111 3098 3096 3097 -2882 111 3101 3099 3100 -2883 111 3104 3102 3103 -2884 111 3107 3105 3106 -2885 111 3110 3108 3109 -2886 111 3113 3111 3112 -2887 111 3116 3114 3115 -2888 111 3119 3117 3118 -2889 111 3122 3120 3121 -2890 111 3125 3123 3124 -2891 111 3128 3126 3127 -2892 111 3131 3129 3130 -2893 111 3134 3132 3133 -2894 111 3137 3135 3136 -2895 111 3140 3138 3139 -2896 111 3143 3141 3142 -2897 111 3146 3144 3145 -2898 111 3149 3147 3148 -2899 111 3152 3150 3151 -2900 111 3155 3153 3154 -2901 111 3158 3156 3157 -2902 111 3161 3159 3160 -2903 111 3164 3162 3163 -2904 111 3167 3165 3166 -2905 111 3170 3168 3169 -2906 111 3173 3171 3172 -2907 111 3176 3174 3175 -2908 111 3179 3177 3178 -2909 111 3182 3180 3181 -2910 111 3185 3183 3184 -2911 111 3188 3186 3187 -2912 111 3191 3189 3190 -2913 111 3194 3192 3193 -2914 111 3197 3195 3196 -2915 111 3200 3198 3199 -2916 111 3203 3201 3202 -2917 111 3206 3204 3205 -2918 111 3209 3207 3208 -2919 111 3212 3210 3211 -2920 111 3215 3213 3214 -2921 111 3218 3216 3217 -2922 111 3221 3219 3220 -2923 111 3224 3222 3223 -2924 111 3227 3225 3226 -2925 111 3230 3228 3229 -2926 111 3233 3231 3232 -2927 111 3236 3234 3235 -2928 111 3239 3237 3238 -2929 111 3242 3240 3241 -2930 111 3245 3243 3244 -2931 111 3248 3246 3247 -2932 111 3251 3249 3250 -2933 111 3254 3252 3253 -2934 111 3257 3255 3256 -2935 111 3260 3258 3259 -2936 111 3263 3261 3262 -2937 111 3266 3264 3265 -2938 111 3269 3267 3268 -2939 111 3272 3270 3271 -2940 111 3275 3273 3274 -2941 111 3278 3276 3277 -2942 111 3281 3279 3280 -2943 111 3284 3282 3283 -2944 111 3287 3285 3286 -2945 111 3290 3288 3289 -2946 111 3293 3291 3292 -2947 111 3296 3294 3295 -2948 111 3299 3297 3298 -2949 111 3302 3300 3301 -2950 111 3305 3303 3304 -2951 111 3308 3306 3307 -2952 111 3311 3309 3310 -2953 111 3314 3312 3313 -2954 111 3317 3315 3316 -2955 111 3320 3318 3319 -2956 111 3323 3321 3322 -2957 111 3326 3324 3325 -2958 111 3329 3327 3328 -2959 111 3332 3330 3331 -2960 111 3335 3333 3334 -2961 111 3338 3336 3337 -2962 111 3341 3339 3340 -2963 111 3344 3342 3343 -2964 111 3347 3345 3346 -2965 111 3350 3348 3349 -2966 111 3353 3351 3352 -2967 111 3356 3354 3355 -2968 111 3359 3357 3358 -2969 111 3362 3360 3361 -2970 111 3365 3363 3364 -2971 111 3368 3366 3367 -2972 111 3371 3369 3370 -2973 111 3374 3372 3373 -2974 111 3377 3375 3376 -2975 111 3380 3378 3379 -2976 111 3383 3381 3382 -2977 111 3386 3384 3385 -2978 111 3389 3387 3388 -2979 111 3392 3390 3391 -2980 111 3395 3393 3394 -2981 111 3398 3396 3397 -2982 111 3401 3399 3400 -2983 111 3404 3402 3403 -2984 111 3407 3405 3406 -2985 111 3410 3408 3409 -2986 111 3413 3411 3412 -2987 111 3416 3414 3415 -2988 111 3419 3417 3418 -2989 111 3422 3420 3421 -2990 111 3425 3423 3424 -2991 111 3428 3426 3427 -2992 111 3431 3429 3430 -2993 111 3434 3432 3433 -2994 111 3437 3435 3436 -2995 111 3440 3438 3439 -2996 111 3443 3441 3442 -2997 111 3446 3444 3445 -2998 111 3449 3447 3448 -2999 111 3452 3450 3451 -3000 111 3455 3453 3454 -3001 111 3458 3456 3457 -3002 111 3461 3459 3460 -3003 111 3464 3462 3463 -3004 111 3467 3465 3466 -3005 111 3470 3468 3469 -3006 111 3473 3471 3472 -3007 111 3476 3474 3475 -3008 111 3479 3477 3478 -3009 111 3482 3480 3481 -3010 111 3485 3483 3484 -3011 111 3488 3486 3487 -3012 111 3491 3489 3490 -3013 111 3494 3492 3493 -3014 111 3497 3495 3496 -3015 111 3500 3498 3499 -3016 111 3503 3501 3502 -3017 111 3506 3504 3505 -3018 111 3509 3507 3508 -3019 111 3512 3510 3511 -3020 111 3515 3513 3514 -3021 111 3518 3516 3517 -3022 111 3521 3519 3520 -3023 111 3524 3522 3523 -3024 111 3527 3525 3526 -3025 111 3530 3528 3529 -3026 111 3533 3531 3532 -3027 111 3536 3534 3535 -3028 111 3539 3537 3538 -3029 111 3542 3540 3541 -3030 111 3545 3543 3544 -3031 111 3548 3546 3547 -3032 111 3551 3549 3550 -3033 111 3554 3552 3553 -3034 111 3557 3555 3556 -3035 111 3560 3558 3559 -3036 111 3563 3561 3562 -3037 111 3566 3564 3565 -3038 111 3569 3567 3568 -3039 111 3572 3570 3571 -3040 111 3575 3573 3574 -3041 111 3578 3576 3577 -3042 111 3581 3579 3580 -3043 111 3584 3582 3583 -3044 111 3587 3585 3586 -3045 111 3590 3588 3589 -3046 111 3593 3591 3592 -3047 111 3596 3594 3595 -3048 111 3599 3597 3598 -3049 111 3602 3600 3601 -3050 111 3605 3603 3604 -3051 111 3608 3606 3607 -3052 111 3611 3609 3610 -3053 111 3614 3612 3613 -3054 111 3617 3615 3616 -3055 111 3620 3618 3619 -3056 111 3623 3621 3622 -3057 111 3626 3624 3625 -3058 111 3629 3627 3628 -3059 111 3632 3630 3631 -3060 111 3635 3633 3634 -3061 111 3638 3636 3637 -3062 111 3641 3639 3640 -3063 111 3644 3642 3643 -3064 111 3647 3645 3646 -3065 111 3650 3648 3649 -3066 111 3653 3651 3652 -3067 111 3656 3654 3655 -3068 111 3659 3657 3658 -3069 111 3662 3660 3661 -3070 111 3665 3663 3664 -3071 111 3668 3666 3667 -3072 111 3671 3669 3670 -3073 111 3674 3672 3673 -3074 111 3677 3675 3676 -3075 111 3680 3678 3679 -3076 111 3683 3681 3682 -3077 111 3686 3684 3685 -3078 111 3689 3687 3688 -3079 111 3692 3690 3691 -3080 111 3695 3693 3694 -3081 111 3698 3696 3697 -3082 111 3701 3699 3700 -3083 111 3704 3702 3703 -3084 111 3707 3705 3706 -3085 111 3710 3708 3709 -3086 111 3713 3711 3712 -3087 111 3716 3714 3715 -3088 111 3719 3717 3718 -3089 111 3722 3720 3721 -3090 111 3725 3723 3724 -3091 111 3728 3726 3727 -3092 111 3731 3729 3730 -3093 111 3734 3732 3733 -3094 111 3737 3735 3736 -3095 111 3740 3738 3739 -3096 111 3743 3741 3742 -3097 111 3746 3744 3745 -3098 111 3749 3747 3748 -3099 111 3752 3750 3751 -3100 111 3755 3753 3754 -3101 111 3758 3756 3757 -3102 111 3761 3759 3760 -3103 111 3764 3762 3763 -3104 111 3767 3765 3766 -3105 111 3770 3768 3769 -3106 111 3773 3771 3772 -3107 111 3776 3774 3775 -3108 111 3779 3777 3778 -3109 111 3782 3780 3781 -3110 111 3785 3783 3784 -3111 111 3788 3786 3787 -3112 111 3791 3789 3790 -3113 111 3794 3792 3793 -3114 111 3797 3795 3796 -3115 111 3800 3798 3799 -3116 111 3803 3801 3802 -3117 111 3806 3804 3805 -3118 111 3809 3807 3808 -3119 111 3812 3810 3811 -3120 111 3815 3813 3814 -3121 111 3818 3816 3817 -3122 111 3821 3819 3820 -3123 111 3824 3822 3823 -3124 111 3827 3825 3826 -3125 111 3830 3828 3829 -3126 111 3833 3831 3832 -3127 111 3836 3834 3835 -3128 111 3839 3837 3838 -3129 111 3842 3840 3841 -3130 111 3845 3843 3844 -3131 111 3848 3846 3847 -3132 111 3851 3849 3850 -3133 111 3854 3852 3853 -3134 111 3857 3855 3856 -3135 111 3860 3858 3859 -3136 111 3863 3861 3862 -3137 111 3866 3864 3865 -3138 111 3869 3867 3868 -3139 111 3872 3870 3871 -3140 111 3875 3873 3874 -3141 111 3878 3876 3877 -3142 111 3881 3879 3880 -3143 111 3884 3882 3883 -3144 111 3887 3885 3886 -3145 111 3890 3888 3889 -3146 111 3893 3891 3892 -3147 111 3896 3894 3895 -3148 111 3899 3897 3898 -3149 111 3902 3900 3901 -3150 111 3905 3903 3904 -3151 111 3908 3906 3907 -3152 111 3911 3909 3910 -3153 111 3914 3912 3913 -3154 111 3917 3915 3916 -3155 111 3920 3918 3919 -3156 111 3923 3921 3922 -3157 111 3926 3924 3925 -3158 111 3929 3927 3928 -3159 111 3932 3930 3931 -3160 111 3935 3933 3934 -3161 111 3938 3936 3937 -3162 111 3941 3939 3940 -3163 111 3944 3942 3943 -3164 111 3947 3945 3946 -3165 111 3950 3948 3949 -3166 111 3953 3951 3952 -3167 111 3956 3954 3955 -3168 111 3959 3957 3958 -3169 111 3962 3960 3961 -3170 111 3965 3963 3964 -3171 111 3968 3966 3967 -3172 111 3971 3969 3970 -3173 111 3974 3972 3973 -3174 111 3977 3975 3976 -3175 111 3980 3978 3979 -3176 111 3983 3981 3982 -3177 111 3986 3984 3985 -3178 111 3989 3987 3988 -3179 111 3992 3990 3991 -3180 111 3995 3993 3994 -3181 111 3998 3996 3997 -3182 111 4001 3999 4000 -3183 111 4004 4002 4003 -3184 111 4007 4005 4006 -3185 111 4010 4008 4009 -3186 111 4013 4011 4012 -3187 111 4016 4014 4015 -3188 111 4019 4017 4018 -3189 111 4022 4020 4021 -3190 111 4025 4023 4024 -3191 111 4028 4026 4027 -3192 111 4031 4029 4030 -3193 111 4034 4032 4033 -3194 111 4037 4035 4036 -3195 111 4040 4038 4039 -3196 111 4043 4041 4042 -3197 111 4046 4044 4045 -3198 111 4049 4047 4048 -3199 111 4052 4050 4051 -3200 111 4055 4053 4054 -3201 111 4058 4056 4057 -3202 111 4061 4059 4060 -3203 111 4064 4062 4063 -3204 111 4067 4065 4066 -3205 111 4070 4068 4069 -3206 111 4073 4071 4072 -3207 111 4076 4074 4075 -3208 111 4079 4077 4078 -3209 111 4082 4080 4081 -3210 111 4085 4083 4084 -3211 111 4088 4086 4087 -3212 111 4091 4089 4090 -3213 111 4094 4092 4093 -3214 111 4097 4095 4096 -3215 111 4100 4098 4099 -3216 111 4103 4101 4102 -3217 111 4106 4104 4105 -3218 111 4109 4107 4108 -3219 111 4112 4110 4111 -3220 111 4115 4113 4114 -3221 111 4118 4116 4117 -3222 111 4121 4119 4120 -3223 111 4124 4122 4123 -3224 111 4127 4125 4126 -3225 111 4130 4128 4129 -3226 111 4133 4131 4132 -3227 111 4136 4134 4135 -3228 111 4139 4137 4138 -3229 111 4142 4140 4141 -3230 111 4145 4143 4144 -3231 111 4148 4146 4147 -3232 111 4151 4149 4150 -3233 111 4154 4152 4153 -3234 111 4157 4155 4156 -3235 111 4160 4158 4159 -3236 111 4163 4161 4162 -3237 111 4166 4164 4165 -3238 111 4169 4167 4168 -3239 111 4172 4170 4171 -3240 111 4175 4173 4174 -3241 111 4178 4176 4177 -3242 111 4181 4179 4180 -3243 111 4184 4182 4183 -3244 111 4187 4185 4186 -3245 111 4190 4188 4189 -3246 111 4193 4191 4192 -3247 111 4196 4194 4195 -3248 111 4199 4197 4198 -3249 111 4202 4200 4201 -3250 111 4205 4203 4204 -3251 111 4208 4206 4207 -3252 111 4211 4209 4210 -3253 111 4214 4212 4213 -3254 111 4217 4215 4216 -3255 111 4220 4218 4219 -3256 111 4223 4221 4222 -3257 111 4226 4224 4225 -3258 111 4229 4227 4228 -3259 111 4232 4230 4231 -3260 111 4235 4233 4234 -3261 111 4238 4236 4237 -3262 111 4241 4239 4240 -3263 111 4244 4242 4243 -3264 111 4247 4245 4246 -3265 111 4250 4248 4249 -3266 111 4253 4251 4252 -3267 111 4256 4254 4255 -3268 111 4259 4257 4258 -3269 111 4262 4260 4261 -3270 111 4265 4263 4264 -3271 111 4268 4266 4267 -3272 111 4271 4269 4270 -3273 111 4274 4272 4273 -3274 111 4277 4275 4276 -3275 111 4280 4278 4279 -3276 111 4283 4281 4282 -3277 111 4286 4284 4285 -3278 111 4289 4287 4288 -3279 111 4292 4290 4291 -3280 111 4295 4293 4294 -3281 111 4298 4296 4297 -3282 111 4301 4299 4300 -3283 111 4304 4302 4303 -3284 111 4307 4305 4306 -3285 111 4310 4308 4309 -3286 111 4313 4311 4312 -3287 111 4316 4314 4315 -3288 111 4319 4317 4318 -3289 111 4322 4320 4321 -3290 111 4325 4323 4324 -3291 111 4328 4326 4327 -3292 111 4331 4329 4330 -3293 111 4334 4332 4333 -3294 111 4337 4335 4336 -3295 111 4340 4338 4339 -3296 111 4343 4341 4342 -3297 111 4346 4344 4345 -3298 111 4349 4347 4348 -3299 111 4352 4350 4351 -3300 111 4355 4353 4354 -3301 111 4358 4356 4357 -3302 111 4361 4359 4360 -3303 111 4364 4362 4363 -3304 111 4367 4365 4366 -3305 111 4370 4368 4369 -3306 111 4373 4371 4372 -3307 111 4376 4374 4375 -3308 111 4379 4377 4378 -3309 111 4382 4380 4381 -3310 111 4385 4383 4384 -3311 111 4388 4386 4387 -3312 111 4391 4389 4390 -3313 111 4394 4392 4393 -3314 111 4397 4395 4396 -3315 111 4400 4398 4399 -3316 111 4403 4401 4402 -3317 111 4406 4404 4405 -3318 111 4409 4407 4408 -3319 111 4412 4410 4411 -3320 111 4415 4413 4414 -3321 111 4418 4416 4417 -3322 111 4421 4419 4420 -3323 111 4424 4422 4423 -3324 111 4427 4425 4426 -3325 111 4430 4428 4429 -3326 111 4433 4431 4432 -3327 111 4436 4434 4435 -3328 111 4439 4437 4438 -3329 111 4442 4440 4441 -3330 111 4445 4443 4444 -3331 111 4448 4446 4447 -3332 111 4451 4449 4450 -3333 111 4454 4452 4453 -3334 111 4457 4455 4456 -3335 111 4460 4458 4459 -3336 111 4463 4461 4462 -3337 111 4466 4464 4465 -3338 111 4469 4467 4468 -3339 111 4472 4470 4471 -3340 111 4475 4473 4474 -3341 111 4478 4476 4477 -3342 111 4481 4479 4480 -3343 111 4484 4482 4483 -3344 111 4487 4485 4486 -3345 111 4490 4488 4489 -3346 111 4493 4491 4492 -3347 111 4496 4494 4495 -3348 111 4499 4497 4498 -3349 111 4502 4500 4501 -3350 111 4505 4503 4504 -3351 111 4508 4506 4507 -3352 111 4511 4509 4510 -3353 111 4514 4512 4513 -3354 111 4517 4515 4516 -3355 111 4520 4518 4519 -3356 111 4523 4521 4522 -3357 111 4526 4524 4525 -3358 111 4529 4527 4528 -3359 111 4532 4530 4531 -3360 111 4535 4533 4534 -3361 111 4538 4536 4537 -3362 111 4541 4539 4540 -3363 111 4544 4542 4543 -3364 111 4547 4545 4546 -3365 111 4550 4548 4549 -3366 111 4553 4551 4552 -3367 111 4556 4554 4555 -3368 111 4559 4557 4558 -3369 111 4562 4560 4561 -3370 111 4565 4563 4564 -3371 111 4568 4566 4567 -3372 111 4571 4569 4570 -3373 111 4574 4572 4573 -3374 111 4577 4575 4576 -3375 111 4580 4578 4579 -3376 111 4583 4581 4582 -3377 111 4586 4584 4585 -3378 111 4589 4587 4588 -3379 111 4592 4590 4591 -3380 111 4595 4593 4594 -3381 111 4598 4596 4597 -3382 111 4601 4599 4600 -3383 111 4604 4602 4603 -3384 111 4607 4605 4606 -3385 111 4610 4608 4609 -3386 111 4613 4611 4612 -3387 111 4616 4614 4615 -3388 111 4619 4617 4618 -3389 111 4622 4620 4621 -3390 111 4625 4623 4624 -3391 111 4628 4626 4627 -3392 111 4631 4629 4630 -3393 111 4634 4632 4633 -3394 111 4637 4635 4636 -3395 111 4640 4638 4639 -3396 111 4643 4641 4642 -3397 111 4646 4644 4645 -3398 111 4649 4647 4648 -3399 111 4652 4650 4651 -3400 111 4655 4653 4654 -3401 111 4658 4656 4657 -3402 111 4661 4659 4660 -3403 111 4664 4662 4663 -3404 111 4667 4665 4666 -3405 111 4670 4668 4669 -3406 111 4673 4671 4672 -3407 111 4676 4674 4675 -3408 111 4679 4677 4678 -3409 111 4682 4680 4681 -3410 111 4685 4683 4684 -3411 111 4688 4686 4687 -3412 111 4691 4689 4690 -3413 111 4694 4692 4693 -3414 111 4697 4695 4696 -3415 111 4700 4698 4699 -3416 111 4703 4701 4702 -3417 111 4706 4704 4705 -3418 111 4709 4707 4708 -3419 111 4712 4710 4711 -3420 111 4715 4713 4714 -3421 111 4718 4716 4717 -3422 111 4721 4719 4720 -3423 111 4724 4722 4723 -3424 111 4727 4725 4726 -3425 111 4730 4728 4729 -3426 111 4733 4731 4732 -3427 111 4736 4734 4735 -3428 111 4739 4737 4738 -3429 111 4742 4740 4741 -3430 111 4745 4743 4744 -3431 111 4748 4746 4747 -3432 111 4751 4749 4750 -3433 111 4754 4752 4753 -3434 111 4757 4755 4756 -3435 111 4760 4758 4759 -3436 111 4763 4761 4762 -3437 111 4766 4764 4765 -3438 111 4769 4767 4768 -3439 111 4772 4770 4771 -3440 111 4775 4773 4774 -3441 111 4778 4776 4777 -3442 111 4781 4779 4780 -3443 111 4784 4782 4783 -3444 111 4787 4785 4786 -3445 111 4790 4788 4789 -3446 111 4793 4791 4792 -3447 111 4796 4794 4795 -3448 111 4799 4797 4798 -3449 111 4802 4800 4801 -3450 111 4805 4803 4804 -3451 111 4808 4806 4807 -3452 111 4811 4809 4810 -3453 111 4814 4812 4813 -3454 111 4817 4815 4816 -3455 111 4820 4818 4819 -3456 111 4823 4821 4822 -3457 111 4826 4824 4825 -3458 111 4829 4827 4828 -3459 111 4832 4830 4831 -3460 111 4835 4833 4834 -3461 111 4838 4836 4837 -3462 111 4841 4839 4840 -3463 111 4844 4842 4843 -3464 111 4847 4845 4846 -3465 111 4850 4848 4849 -3466 111 4853 4851 4852 -3467 111 4856 4854 4855 -3468 111 4859 4857 4858 -3469 111 4862 4860 4861 -3470 111 4865 4863 4864 -3471 111 4868 4866 4867 -3472 111 4871 4869 4870 -3473 111 4874 4872 4873 -3474 111 4877 4875 4876 -3475 111 4880 4878 4879 -3476 111 4883 4881 4882 -3477 111 4886 4884 4885 -3478 111 4889 4887 4888 -3479 111 4892 4890 4891 -3480 111 4895 4893 4894 -3481 111 4898 4896 4897 -3482 111 4901 4899 4900 -3483 111 4904 4902 4903 -3484 111 4907 4905 4906 -3485 111 4910 4908 4909 -3486 111 4913 4911 4912 -3487 111 4916 4914 4915 -3488 111 4919 4917 4918 -3489 111 4922 4920 4921 -3490 111 4925 4923 4924 -3491 111 4928 4926 4927 -3492 111 4931 4929 4930 -3493 111 4934 4932 4933 -3494 111 4937 4935 4936 -3495 111 4940 4938 4939 -3496 111 4943 4941 4942 -3497 111 4946 4944 4945 -3498 111 4949 4947 4948 -3499 111 4952 4950 4951 -3500 111 4955 4953 4954 -3501 111 4958 4956 4957 -3502 111 4961 4959 4960 -3503 111 4964 4962 4963 -3504 111 4967 4965 4966 -3505 111 4970 4968 4969 -3506 111 4973 4971 4972 -3507 111 4976 4974 4975 -3508 111 4979 4977 4978 -3509 111 4982 4980 4981 -3510 111 4985 4983 4984 -3511 111 4988 4986 4987 -3512 111 4991 4989 4990 -3513 111 4994 4992 4993 -3514 111 4997 4995 4996 -3515 111 5000 4998 4999 -3516 111 5003 5001 5002 -3517 111 5006 5004 5005 -3518 111 5009 5007 5008 -3519 111 5012 5010 5011 -3520 111 5015 5013 5014 -3521 111 5018 5016 5017 -3522 111 5021 5019 5020 -3523 111 5024 5022 5023 -3524 111 5027 5025 5026 -3525 111 5030 5028 5029 -3526 111 5033 5031 5032 -3527 111 5036 5034 5035 -3528 111 5039 5037 5038 -3529 111 5042 5040 5041 -3530 111 5045 5043 5044 -3531 111 5048 5046 5047 -3532 111 5051 5049 5050 -3533 111 5054 5052 5053 -3534 111 5057 5055 5056 -3535 111 5060 5058 5059 -3536 111 5063 5061 5062 -3537 111 5066 5064 5065 -3538 111 5069 5067 5068 -3539 111 5072 5070 5071 -3540 111 5075 5073 5074 -3541 111 5078 5076 5077 -3542 111 5081 5079 5080 -3543 111 5084 5082 5083 -3544 111 5087 5085 5086 -3545 111 5090 5088 5089 -3546 111 5093 5091 5092 -3547 111 5096 5094 5095 -3548 111 5099 5097 5098 -3549 111 5102 5100 5101 -3550 111 5105 5103 5104 -3551 111 5108 5106 5107 -3552 111 5111 5109 5110 -3553 111 5114 5112 5113 -3554 111 5117 5115 5116 -3555 111 5120 5118 5119 -3556 111 5123 5121 5122 -3557 111 5126 5124 5125 -3558 111 5129 5127 5128 -3559 111 5132 5130 5131 -3560 111 5135 5133 5134 -3561 111 5138 5136 5137 -3562 111 5141 5139 5140 -3563 111 5144 5142 5143 -3564 111 5147 5145 5146 -3565 111 5150 5148 5149 -3566 111 5153 5151 5152 -3567 111 5156 5154 5155 -3568 111 5159 5157 5158 -3569 111 5162 5160 5161 -3570 111 5165 5163 5164 -3571 111 5168 5166 5167 -3572 111 5171 5169 5170 -3573 111 5174 5172 5173 -3574 111 5177 5175 5176 -3575 111 5180 5178 5179 -3576 111 5183 5181 5182 -3577 111 5186 5184 5185 -3578 111 5189 5187 5188 -3579 111 5192 5190 5191 -3580 111 5195 5193 5194 -3581 111 5198 5196 5197 -3582 111 5201 5199 5200 -3583 111 5204 5202 5203 -3584 111 5207 5205 5206 -3585 111 5210 5208 5209 -3586 111 5213 5211 5212 -3587 111 5216 5214 5215 -3588 111 5219 5217 5218 -3589 111 5222 5220 5221 -3590 111 5225 5223 5224 -3591 111 5228 5226 5227 -3592 111 5231 5229 5230 -3593 111 5234 5232 5233 -3594 111 5237 5235 5236 -3595 111 5240 5238 5239 -3596 111 5243 5241 5242 -3597 111 5246 5244 5245 -3598 111 5249 5247 5248 -3599 111 5252 5250 5251 -3600 111 5255 5253 5254 -3601 111 5258 5256 5257 -3602 111 5261 5259 5260 -3603 111 5264 5262 5263 -3604 111 5267 5265 5266 -3605 111 5270 5268 5269 -3606 111 5273 5271 5272 -3607 111 5276 5274 5275 -3608 111 5279 5277 5278 -3609 111 5282 5280 5281 -3610 111 5285 5283 5284 -3611 111 5288 5286 5287 -3612 111 5291 5289 5290 -3613 111 5294 5292 5293 -3614 111 5297 5295 5296 -3615 111 5300 5298 5299 -3616 111 5303 5301 5302 -3617 111 5306 5304 5305 -3618 111 5309 5307 5308 -3619 111 5312 5310 5311 -3620 111 5315 5313 5314 -3621 111 5318 5316 5317 -3622 111 5321 5319 5320 -3623 111 5324 5322 5323 -3624 111 5327 5325 5326 -3625 111 5330 5328 5329 -3626 111 5333 5331 5332 -3627 111 5336 5334 5335 -3628 111 5339 5337 5338 -3629 111 5342 5340 5341 -3630 111 5345 5343 5344 -3631 111 5348 5346 5347 -3632 111 5351 5349 5350 -3633 111 5354 5352 5353 -3634 111 5357 5355 5356 -3635 111 5360 5358 5359 -3636 111 5363 5361 5362 -3637 111 5366 5364 5365 -3638 111 5369 5367 5368 -3639 111 5372 5370 5371 -3640 111 5375 5373 5374 -3641 111 5378 5376 5377 -3642 111 5381 5379 5380 -3643 111 5384 5382 5383 -3644 111 5387 5385 5386 -3645 111 5390 5388 5389 -3646 111 5393 5391 5392 -3647 111 5396 5394 5395 -3648 111 5399 5397 5398 -3649 111 5402 5400 5401 -3650 111 5405 5403 5404 -3651 111 5408 5406 5407 -3652 111 5411 5409 5410 -3653 111 5414 5412 5413 -3654 111 5417 5415 5416 -3655 111 5420 5418 5419 -3656 111 5423 5421 5422 -3657 111 5426 5424 5425 -3658 111 5429 5427 5428 -3659 111 5432 5430 5431 -3660 111 5435 5433 5434 -3661 111 5438 5436 5437 -3662 111 5441 5439 5440 -3663 111 5444 5442 5443 -3664 111 5447 5445 5446 -3665 111 5450 5448 5449 -3666 111 5453 5451 5452 -3667 111 5456 5454 5455 -3668 111 5459 5457 5458 -3669 111 5462 5460 5461 -3670 111 5465 5463 5464 -3671 111 5468 5466 5467 -3672 111 5471 5469 5470 -3673 111 5474 5472 5473 -3674 111 5477 5475 5476 -3675 111 5480 5478 5479 -3676 111 5483 5481 5482 -3677 111 5486 5484 5485 -3678 111 5489 5487 5488 -3679 111 5492 5490 5491 -3680 111 5495 5493 5494 -3681 111 5498 5496 5497 -3682 111 5501 5499 5500 -3683 111 5504 5502 5503 -3684 111 5507 5505 5506 -3685 111 5510 5508 5509 -3686 111 5513 5511 5512 -3687 111 5516 5514 5515 -3688 111 5519 5517 5518 -3689 111 5522 5520 5521 -3690 111 5525 5523 5524 -3691 111 5528 5526 5527 -3692 111 5531 5529 5530 -3693 111 5534 5532 5533 -3694 111 5537 5535 5536 -3695 111 5540 5538 5539 -3696 111 5543 5541 5542 -3697 111 5546 5544 5545 -3698 111 5549 5547 5548 -3699 111 5552 5550 5551 -3700 111 5555 5553 5554 -3701 111 5558 5556 5557 -3702 111 5561 5559 5560 -3703 111 5564 5562 5563 -3704 111 5567 5565 5566 -3705 111 5570 5568 5569 -3706 111 5573 5571 5572 -3707 111 5576 5574 5575 -3708 111 5579 5577 5578 -3709 111 5582 5580 5581 -3710 111 5585 5583 5584 -3711 111 5588 5586 5587 -3712 111 5591 5589 5590 -3713 111 5594 5592 5593 -3714 111 5597 5595 5596 -3715 111 5600 5598 5599 -3716 111 5603 5601 5602 -3717 111 5606 5604 5605 -3718 111 5609 5607 5608 -3719 111 5612 5610 5611 -3720 111 5615 5613 5614 -3721 111 5618 5616 5617 -3722 111 5621 5619 5620 -3723 111 5624 5622 5623 -3724 111 5627 5625 5626 -3725 111 5630 5628 5629 -3726 111 5633 5631 5632 -3727 111 5636 5634 5635 -3728 111 5639 5637 5638 -3729 111 5642 5640 5641 -3730 111 5645 5643 5644 -3731 111 5648 5646 5647 -3732 111 5651 5649 5650 -3733 111 5654 5652 5653 -3734 111 5657 5655 5656 -3735 111 5660 5658 5659 -3736 111 5663 5661 5662 -3737 111 5666 5664 5665 -3738 111 5669 5667 5668 -3739 111 5672 5670 5671 -3740 111 5675 5673 5674 -3741 111 5678 5676 5677 -3742 111 5681 5679 5680 -3743 111 5684 5682 5683 -3744 111 5687 5685 5686 -3745 111 5690 5688 5689 -3746 111 5693 5691 5692 -3747 111 5696 5694 5695 -3748 111 5699 5697 5698 -3749 111 5702 5700 5701 -3750 111 5705 5703 5704 -3751 111 5708 5706 5707 -3752 111 5711 5709 5710 -3753 111 5714 5712 5713 -3754 111 5717 5715 5716 -3755 111 5720 5718 5719 -3756 111 5723 5721 5722 -3757 111 5726 5724 5725 -3758 111 5729 5727 5728 -3759 111 5732 5730 5731 -3760 111 5735 5733 5734 -3761 111 5738 5736 5737 -3762 111 5741 5739 5740 -3763 111 5744 5742 5743 -3764 111 5747 5745 5746 -3765 111 5750 5748 5749 -3766 111 5753 5751 5752 -3767 111 5756 5754 5755 -3768 111 5759 5757 5758 -3769 111 5762 5760 5761 -3770 111 5765 5763 5764 -3771 111 5768 5766 5767 -3772 111 5771 5769 5770 -3773 111 5774 5772 5773 -3774 111 5777 5775 5776 -3775 111 5780 5778 5779 -3776 111 5783 5781 5782 -3777 111 5786 5784 5785 -3778 111 5789 5787 5788 -3779 111 5792 5790 5791 -3780 111 5795 5793 5794 -3781 111 5798 5796 5797 -3782 111 5801 5799 5800 -3783 111 5804 5802 5803 -3784 111 5807 5805 5806 -3785 111 5810 5808 5809 -3786 111 5813 5811 5812 -3787 111 5816 5814 5815 -3788 111 5819 5817 5818 -3789 111 5822 5820 5821 -3790 111 5825 5823 5824 -3791 111 5828 5826 5827 -3792 111 5831 5829 5830 -3793 111 5834 5832 5833 -3794 111 5837 5835 5836 -3795 111 5840 5838 5839 -3796 111 5843 5841 5842 -3797 111 5846 5844 5845 -3798 111 5849 5847 5848 -3799 111 5852 5850 5851 -3800 111 5855 5853 5854 -3801 111 5858 5856 5857 -3802 111 5861 5859 5860 -3803 111 5864 5862 5863 -3804 111 5867 5865 5866 -3805 111 5870 5868 5869 -3806 111 5873 5871 5872 -3807 111 5876 5874 5875 -3808 111 5879 5877 5878 -3809 111 5882 5880 5881 -3810 111 5885 5883 5884 -3811 111 5888 5886 5887 -3812 111 5891 5889 5890 -3813 111 5894 5892 5893 -3814 111 5897 5895 5896 -3815 111 5900 5898 5899 -3816 111 5903 5901 5902 -3817 111 5906 5904 5905 -3818 111 5909 5907 5908 -3819 111 5912 5910 5911 -3820 111 5915 5913 5914 -3821 111 5918 5916 5917 -3822 111 5921 5919 5920 -3823 111 5924 5922 5923 -3824 111 5927 5925 5926 -3825 111 5930 5928 5929 -3826 111 5933 5931 5932 -3827 111 5936 5934 5935 -3828 111 5939 5937 5938 -3829 111 5942 5940 5941 -3830 111 5945 5943 5944 -3831 111 5948 5946 5947 -3832 111 5951 5949 5950 -3833 111 5954 5952 5953 -3834 111 5957 5955 5956 -3835 111 5960 5958 5959 -3836 111 5963 5961 5962 -3837 111 5966 5964 5965 -3838 111 5969 5967 5968 -3839 111 5972 5970 5971 -3840 111 5975 5973 5974 -3841 111 5978 5976 5977 -3842 111 5981 5979 5980 -3843 111 5984 5982 5983 -3844 111 5987 5985 5986 -3845 111 5990 5988 5989 -3846 111 5993 5991 5992 -3847 111 5996 5994 5995 -3848 111 5999 5997 5998 -3849 111 6002 6000 6001 -3850 111 6005 6003 6004 -3851 111 6008 6006 6007 -3852 111 6011 6009 6010 -3853 111 6014 6012 6013 -3854 111 6017 6015 6016 -3855 111 6020 6018 6019 -3856 111 6023 6021 6022 -3857 111 6026 6024 6025 -3858 111 6029 6027 6028 -3859 111 6032 6030 6031 -3860 111 6035 6033 6034 -3861 111 6038 6036 6037 -3862 111 6041 6039 6040 -3863 111 6044 6042 6043 -3864 111 6047 6045 6046 -3865 111 6050 6048 6049 -3866 111 6053 6051 6052 -3867 111 6056 6054 6055 -3868 111 6059 6057 6058 -3869 111 6062 6060 6061 -3870 111 6065 6063 6064 -3871 111 6068 6066 6067 -3872 111 6071 6069 6070 -3873 111 6074 6072 6073 -3874 111 6077 6075 6076 -3875 111 6080 6078 6079 -3876 111 6083 6081 6082 -3877 111 6086 6084 6085 -3878 111 6089 6087 6088 -3879 111 6092 6090 6091 -3880 111 6095 6093 6094 -3881 111 6098 6096 6097 -3882 111 6101 6099 6100 -3883 111 6104 6102 6103 -3884 111 6107 6105 6106 -3885 111 6110 6108 6109 -3886 111 6113 6111 6112 -3887 111 6116 6114 6115 -3888 111 6119 6117 6118 -3889 111 6122 6120 6121 -3890 111 6125 6123 6124 -3891 111 6128 6126 6127 -3892 111 6131 6129 6130 -3893 111 6134 6132 6133 -3894 111 6137 6135 6136 -3895 111 6140 6138 6139 -3896 111 6143 6141 6142 -3897 111 6146 6144 6145 -3898 111 6149 6147 6148 -3899 111 6152 6150 6151 -3900 111 6155 6153 6154 -3901 111 6158 6156 6157 -3902 111 6161 6159 6160 -3903 111 6164 6162 6163 -3904 111 6167 6165 6166 -3905 111 6170 6168 6169 -3906 111 6173 6171 6172 -3907 111 6176 6174 6175 -3908 111 6179 6177 6178 -3909 111 6182 6180 6181 -3910 111 6185 6183 6184 -3911 111 6188 6186 6187 -3912 111 6191 6189 6190 -3913 111 6194 6192 6193 -3914 111 6197 6195 6196 -3915 111 6200 6198 6199 -3916 111 6203 6201 6202 -3917 111 6206 6204 6205 -3918 111 6209 6207 6208 -3919 111 6212 6210 6211 -3920 111 6215 6213 6214 -3921 111 6218 6216 6217 -3922 111 6221 6219 6220 -3923 111 6224 6222 6223 -3924 111 6227 6225 6226 -3925 111 6230 6228 6229 -3926 111 6233 6231 6232 -3927 111 6236 6234 6235 -3928 111 6239 6237 6238 -3929 111 6242 6240 6241 -3930 111 6245 6243 6244 -3931 111 6248 6246 6247 -3932 111 6251 6249 6250 -3933 111 6254 6252 6253 -3934 111 6257 6255 6256 -3935 111 6260 6258 6259 -3936 111 6263 6261 6262 -3937 111 6266 6264 6265 -3938 111 6269 6267 6268 -3939 111 6272 6270 6271 -3940 111 6275 6273 6274 -3941 111 6278 6276 6277 -3942 111 6281 6279 6280 -3943 111 6284 6282 6283 -3944 111 6287 6285 6286 -3945 111 6290 6288 6289 -3946 111 6293 6291 6292 -3947 111 6296 6294 6295 -3948 111 6299 6297 6298 -3949 111 6302 6300 6301 -3950 111 6305 6303 6304 -3951 111 6308 6306 6307 -3952 111 6311 6309 6310 -3953 111 6314 6312 6313 -3954 111 6317 6315 6316 -3955 111 6320 6318 6319 -3956 111 6323 6321 6322 -3957 111 6326 6324 6325 -3958 111 6329 6327 6328 -3959 111 6332 6330 6331 -3960 111 6335 6333 6334 -3961 111 6338 6336 6337 -3962 111 6341 6339 6340 -3963 111 6344 6342 6343 -3964 111 6347 6345 6346 -3965 111 6350 6348 6349 -3966 111 6353 6351 6352 -3967 111 6356 6354 6355 -3968 111 6359 6357 6358 -3969 111 6362 6360 6361 -3970 111 6365 6363 6364 -3971 111 6368 6366 6367 -3972 111 6371 6369 6370 -3973 111 6374 6372 6373 -3974 111 6377 6375 6376 -3975 111 6380 6378 6379 -3976 111 6383 6381 6382 -3977 111 6386 6384 6385 -3978 111 6389 6387 6388 -3979 111 6392 6390 6391 -3980 111 6395 6393 6394 -3981 111 6398 6396 6397 -3982 111 6401 6399 6400 -3983 111 6404 6402 6403 -3984 111 6407 6405 6406 -3985 111 6410 6408 6409 -3986 111 6413 6411 6412 -3987 111 6416 6414 6415 -3988 111 6419 6417 6418 -3989 111 6422 6420 6421 -3990 111 6425 6423 6424 -3991 111 6428 6426 6427 -3992 111 6431 6429 6430 -3993 111 6434 6432 6433 -3994 111 6437 6435 6436 -3995 111 6440 6438 6439 -3996 111 6443 6441 6442 -3997 111 6446 6444 6445 -3998 111 6449 6447 6448 -3999 111 6452 6450 6451 -4000 111 6455 6453 6454 -4001 111 6458 6456 6457 -4002 111 6461 6459 6460 -4003 111 6464 6462 6463 -4004 111 6467 6465 6466 -4005 111 6470 6468 6469 -4006 111 6473 6471 6472 -4007 111 6476 6474 6475 -4008 111 6479 6477 6478 -4009 111 6482 6480 6481 -4010 111 6485 6483 6484 -4011 111 6488 6486 6487 -4012 111 6491 6489 6490 -4013 111 6494 6492 6493 -4014 111 6497 6495 6496 -4015 111 6500 6498 6499 -4016 111 6503 6501 6502 -4017 111 6506 6504 6505 -4018 111 6509 6507 6508 -4019 111 6512 6510 6511 -4020 111 6515 6513 6514 -4021 111 6518 6516 6517 -4022 111 6521 6519 6520 -4023 111 6524 6522 6523 -4024 111 6527 6525 6526 -4025 111 6530 6528 6529 -4026 111 6533 6531 6532 -4027 111 6536 6534 6535 -4028 111 6539 6537 6538 -4029 111 6542 6540 6541 -4030 111 6545 6543 6544 -4031 111 6548 6546 6547 -4032 111 6551 6549 6550 -4033 111 6554 6552 6553 -4034 111 6557 6555 6556 -4035 111 6560 6558 6559 -4036 111 6563 6561 6562 -4037 111 6566 6564 6565 -4038 111 6569 6567 6568 -4039 111 6572 6570 6571 -4040 111 6575 6573 6574 -4041 111 6578 6576 6577 -4042 111 6581 6579 6580 -4043 111 6584 6582 6583 -4044 111 6587 6585 6586 -4045 111 6590 6588 6589 -4046 111 6593 6591 6592 -4047 111 6596 6594 6595 -4048 111 6599 6597 6598 -4049 111 6602 6600 6601 -4050 111 6605 6603 6604 -4051 111 6608 6606 6607 -4052 111 6611 6609 6610 -4053 111 6614 6612 6613 -4054 111 6617 6615 6616 -4055 111 6620 6618 6619 -4056 111 6623 6621 6622 -4057 111 6626 6624 6625 -4058 111 6629 6627 6628 -4059 111 6632 6630 6631 -4060 111 6635 6633 6634 -4061 111 6638 6636 6637 -4062 111 6641 6639 6640 -4063 111 6644 6642 6643 -4064 111 6647 6645 6646 -4065 111 6650 6648 6649 -4066 111 6653 6651 6652 -4067 111 6656 6654 6655 -4068 111 6659 6657 6658 -4069 111 6662 6660 6661 -4070 111 6665 6663 6664 -4071 111 6668 6666 6667 -4072 111 6671 6669 6670 -4073 111 6674 6672 6673 -4074 111 6677 6675 6676 -4075 111 6680 6678 6679 -4076 111 6683 6681 6682 -4077 111 6686 6684 6685 -4078 111 6689 6687 6688 -4079 111 6692 6690 6691 -4080 111 6695 6693 6694 -4081 111 6698 6696 6697 -4082 111 6701 6699 6700 -4083 111 6704 6702 6703 -4084 111 6707 6705 6706 -4085 111 6710 6708 6709 -4086 111 6713 6711 6712 -4087 111 6716 6714 6715 -4088 111 6719 6717 6718 -4089 111 6722 6720 6721 -4090 111 6725 6723 6724 -4091 111 6728 6726 6727 -4092 111 6731 6729 6730 -4093 111 6734 6732 6733 -4094 111 6737 6735 6736 -4095 111 6740 6738 6739 -4096 111 6743 6741 6742 -4097 111 6746 6744 6745 -4098 111 6749 6747 6748 -4099 111 6752 6750 6751 -4100 111 6755 6753 6754 -4101 111 6758 6756 6757 -4102 111 6761 6759 6760 -4103 111 6764 6762 6763 -4104 111 6767 6765 6766 -4105 111 6770 6768 6769 -4106 111 6773 6771 6772 -4107 111 6776 6774 6775 -4108 111 6779 6777 6778 -4109 111 6782 6780 6781 -4110 111 6785 6783 6784 -4111 111 6788 6786 6787 -4112 111 6791 6789 6790 -4113 111 6794 6792 6793 -4114 111 6797 6795 6796 -4115 111 6800 6798 6799 -4116 111 6803 6801 6802 -4117 111 6806 6804 6805 -4118 111 6809 6807 6808 -4119 111 6812 6810 6811 -4120 111 6815 6813 6814 -4121 111 6818 6816 6817 -4122 111 6821 6819 6820 -4123 111 6824 6822 6823 -4124 111 6827 6825 6826 -4125 111 6830 6828 6829 -4126 111 6833 6831 6832 -4127 111 6836 6834 6835 -4128 111 6839 6837 6838 -4129 111 6842 6840 6841 -4130 111 6845 6843 6844 -4131 111 6848 6846 6847 -4132 111 6851 6849 6850 -4133 111 6854 6852 6853 -4134 111 6857 6855 6856 -4135 111 6860 6858 6859 -4136 111 6863 6861 6862 -4137 111 6866 6864 6865 -4138 111 6869 6867 6868 -4139 111 6872 6870 6871 -4140 111 6875 6873 6874 -4141 111 6878 6876 6877 -4142 111 6881 6879 6880 -4143 111 6884 6882 6883 -4144 111 6887 6885 6886 -4145 111 6890 6888 6889 -4146 111 6893 6891 6892 -4147 111 6896 6894 6895 -4148 111 6899 6897 6898 -4149 111 6902 6900 6901 -4150 111 6905 6903 6904 -4151 111 6908 6906 6907 -4152 111 6911 6909 6910 -4153 111 6914 6912 6913 -4154 111 6917 6915 6916 -4155 111 6920 6918 6919 -4156 111 6923 6921 6922 -4157 111 6926 6924 6925 -4158 111 6929 6927 6928 -4159 111 6932 6930 6931 -4160 111 6935 6933 6934 -4161 111 6938 6936 6937 -4162 111 6941 6939 6940 -4163 111 6944 6942 6943 -4164 111 6947 6945 6946 -4165 111 6950 6948 6949 -4166 111 6953 6951 6952 -4167 111 6956 6954 6955 -4168 111 6959 6957 6958 -4169 111 6962 6960 6961 -4170 111 6965 6963 6964 -4171 111 6968 6966 6967 -4172 111 6971 6969 6970 -4173 111 6974 6972 6973 -4174 111 6977 6975 6976 -4175 111 6980 6978 6979 -4176 111 6983 6981 6982 -4177 111 6986 6984 6985 -4178 111 6989 6987 6988 -4179 111 6992 6990 6991 -4180 111 6995 6993 6994 -4181 111 6998 6996 6997 -4182 111 7001 6999 7000 -4183 111 7004 7002 7003 -4184 111 7007 7005 7006 -4185 111 7010 7008 7009 -4186 111 7013 7011 7012 -4187 111 7016 7014 7015 -4188 111 7019 7017 7018 -4189 111 7022 7020 7021 -4190 111 7025 7023 7024 -4191 111 7028 7026 7027 -4192 111 7031 7029 7030 -4193 111 7034 7032 7033 -4194 111 7037 7035 7036 -4195 111 7040 7038 7039 -4196 111 7043 7041 7042 -4197 111 7046 7044 7045 -4198 111 7049 7047 7048 -4199 111 7052 7050 7051 -4200 111 7055 7053 7054 -4201 111 7058 7056 7057 -4202 111 7061 7059 7060 -4203 111 7064 7062 7063 -4204 111 7067 7065 7066 -4205 111 7070 7068 7069 -4206 111 7073 7071 7072 -4207 111 7076 7074 7075 -4208 111 7079 7077 7078 -4209 111 7082 7080 7081 -4210 111 7085 7083 7084 -4211 111 7088 7086 7087 -4212 111 7091 7089 7090 -4213 111 7094 7092 7093 -4214 111 7097 7095 7096 -4215 111 7100 7098 7099 -4216 111 7103 7101 7102 -4217 111 7106 7104 7105 -4218 111 7109 7107 7108 -4219 111 7112 7110 7111 -4220 111 7115 7113 7114 -4221 111 7118 7116 7117 -4222 111 7121 7119 7120 -4223 111 7124 7122 7123 -4224 111 7127 7125 7126 -4225 111 7130 7128 7129 -4226 111 7133 7131 7132 -4227 111 7136 7134 7135 -4228 111 7139 7137 7138 -4229 111 7142 7140 7141 -4230 111 7145 7143 7144 -4231 111 7148 7146 7147 -4232 111 7151 7149 7150 -4233 111 7154 7152 7153 -4234 111 7157 7155 7156 -4235 111 7160 7158 7159 -4236 111 7163 7161 7162 -4237 111 7166 7164 7165 -4238 111 7169 7167 7168 -4239 111 7172 7170 7171 -4240 111 7175 7173 7174 -4241 111 7178 7176 7177 -4242 111 7181 7179 7180 -4243 111 7184 7182 7183 -4244 111 7187 7185 7186 -4245 111 7190 7188 7189 -4246 111 7193 7191 7192 -4247 111 7196 7194 7195 -4248 111 7199 7197 7198 -4249 111 7202 7200 7201 -4250 111 7205 7203 7204 -4251 111 7208 7206 7207 -4252 111 7211 7209 7210 -4253 111 7214 7212 7213 -4254 111 7217 7215 7216 -4255 111 7220 7218 7219 -4256 111 7223 7221 7222 -4257 111 7226 7224 7225 -4258 111 7229 7227 7228 -4259 111 7232 7230 7231 -4260 111 7235 7233 7234 -4261 111 7238 7236 7237 -4262 111 7241 7239 7240 -4263 111 7244 7242 7243 -4264 111 7247 7245 7246 -4265 111 7250 7248 7249 -4266 111 7253 7251 7252 -4267 111 7256 7254 7255 -4268 111 7259 7257 7258 -4269 111 7262 7260 7261 -4270 111 7265 7263 7264 -4271 111 7268 7266 7267 -4272 111 7271 7269 7270 -4273 111 7274 7272 7273 -4274 111 7277 7275 7276 -4275 111 7280 7278 7279 -4276 111 7283 7281 7282 -4277 111 7286 7284 7285 -4278 111 7289 7287 7288 -4279 111 7292 7290 7291 -4280 111 7295 7293 7294 -4281 111 7298 7296 7297 -4282 111 7301 7299 7300 -4283 111 7304 7302 7303 -4284 111 7307 7305 7306 -4285 111 7310 7308 7309 -4286 111 7313 7311 7312 -4287 111 7316 7314 7315 -4288 111 7319 7317 7318 -4289 111 7322 7320 7321 -4290 111 7325 7323 7324 -4291 111 7328 7326 7327 -4292 111 7331 7329 7330 -4293 111 7334 7332 7333 -4294 111 7337 7335 7336 -4295 111 7340 7338 7339 -4296 111 7343 7341 7342 -4297 111 7346 7344 7345 -4298 111 7349 7347 7348 -4299 111 7352 7350 7351 -4300 111 7355 7353 7354 -4301 111 7358 7356 7357 -4302 111 7361 7359 7360 -4303 111 7364 7362 7363 -4304 111 7367 7365 7366 -4305 111 7370 7368 7369 -4306 111 7373 7371 7372 -4307 111 7376 7374 7375 -4308 111 7379 7377 7378 -4309 111 7382 7380 7381 -4310 111 7385 7383 7384 -4311 111 7388 7386 7387 -4312 111 7391 7389 7390 -4313 111 7394 7392 7393 -4314 111 7397 7395 7396 -4315 111 7400 7398 7399 -4316 111 7403 7401 7402 -4317 111 7406 7404 7405 -4318 111 7409 7407 7408 -4319 111 7412 7410 7411 -4320 111 7415 7413 7414 -4321 111 7418 7416 7417 -4322 111 7421 7419 7420 -4323 111 7424 7422 7423 -4324 111 7427 7425 7426 -4325 111 7430 7428 7429 -4326 111 7433 7431 7432 -4327 111 7436 7434 7435 -4328 111 7439 7437 7438 -4329 111 7442 7440 7441 -4330 111 7445 7443 7444 -4331 111 7448 7446 7447 -4332 111 7451 7449 7450 -4333 111 7454 7452 7453 -4334 111 7457 7455 7456 -4335 111 7460 7458 7459 -4336 111 7463 7461 7462 -4337 111 7466 7464 7465 -4338 111 7469 7467 7468 -4339 111 7472 7470 7471 -4340 111 7475 7473 7474 -4341 111 7478 7476 7477 -4342 111 7481 7479 7480 -4343 111 7484 7482 7483 -4344 111 7487 7485 7486 -4345 111 7490 7488 7489 -4346 111 7493 7491 7492 -4347 111 7496 7494 7495 -4348 111 7499 7497 7498 -4349 111 7502 7500 7501 -4350 111 7505 7503 7504 -4351 111 7508 7506 7507 -4352 111 7511 7509 7510 -4353 111 7514 7512 7513 -4354 111 7517 7515 7516 -4355 111 7520 7518 7519 -4356 111 7523 7521 7522 -4357 111 7526 7524 7525 -4358 111 7529 7527 7528 -4359 111 7532 7530 7531 -4360 111 7535 7533 7534 -4361 111 7538 7536 7537 -4362 111 7541 7539 7540 -4363 111 7544 7542 7543 -4364 111 7547 7545 7546 -4365 111 7550 7548 7549 -4366 111 7553 7551 7552 -4367 111 7556 7554 7555 -4368 111 7559 7557 7558 -4369 111 7562 7560 7561 -4370 111 7565 7563 7564 -4371 111 7568 7566 7567 -4372 111 7571 7569 7570 -4373 111 7574 7572 7573 -4374 111 7577 7575 7576 -4375 111 7580 7578 7579 -4376 111 7583 7581 7582 -4377 111 7586 7584 7585 -4378 111 7589 7587 7588 -4379 111 7592 7590 7591 -4380 111 7595 7593 7594 -4381 111 7598 7596 7597 -4382 111 7601 7599 7600 -4383 111 7604 7602 7603 -4384 111 7607 7605 7606 -4385 111 7610 7608 7609 -4386 111 7613 7611 7612 -4387 111 7616 7614 7615 -4388 111 7619 7617 7618 -4389 111 7622 7620 7621 -4390 111 7625 7623 7624 -4391 111 7628 7626 7627 -4392 111 7631 7629 7630 -4393 111 7634 7632 7633 -4394 111 7637 7635 7636 -4395 111 7640 7638 7639 -4396 111 7643 7641 7642 -4397 111 7646 7644 7645 -4398 111 7649 7647 7648 -4399 111 7652 7650 7651 -4400 111 7655 7653 7654 -4401 111 7658 7656 7657 -4402 111 7661 7659 7660 -4403 111 7664 7662 7663 -4404 111 7667 7665 7666 -4405 111 7670 7668 7669 -4406 111 7673 7671 7672 -4407 111 7676 7674 7675 -4408 111 7679 7677 7678 -4409 111 7682 7680 7681 -4410 111 7685 7683 7684 -4411 111 7688 7686 7687 -4412 111 7691 7689 7690 -4413 111 7694 7692 7693 -4414 111 7697 7695 7696 -4415 111 7700 7698 7699 -4416 111 7703 7701 7702 -4417 111 7706 7704 7705 -4418 111 7709 7707 7708 -4419 111 7712 7710 7711 -4420 111 7715 7713 7714 -4421 111 7718 7716 7717 -4422 111 7721 7719 7720 -4423 111 7724 7722 7723 -4424 111 7727 7725 7726 -4425 111 7730 7728 7729 -4426 111 7733 7731 7732 -4427 111 7736 7734 7735 -4428 111 7739 7737 7738 -4429 111 7742 7740 7741 -4430 111 7745 7743 7744 -4431 111 7748 7746 7747 -4432 111 7751 7749 7750 -4433 111 7754 7752 7753 -4434 111 7757 7755 7756 -4435 111 7760 7758 7759 -4436 111 7763 7761 7762 -4437 111 7766 7764 7765 -4438 111 7769 7767 7768 -4439 111 7772 7770 7771 -4440 111 7775 7773 7774 -4441 111 7778 7776 7777 -4442 111 7781 7779 7780 -4443 111 7784 7782 7783 -4444 111 7787 7785 7786 -4445 111 7790 7788 7789 -4446 111 7793 7791 7792 -4447 111 7796 7794 7795 -4448 111 7799 7797 7798 -4449 111 7802 7800 7801 -4450 111 7805 7803 7804 -4451 111 7808 7806 7807 -4452 111 7811 7809 7810 -4453 111 7814 7812 7813 -4454 111 7817 7815 7816 -4455 111 7820 7818 7819 -4456 111 7823 7821 7822 -4457 111 7826 7824 7825 -4458 111 7829 7827 7828 -4459 111 7832 7830 7831 -4460 111 7835 7833 7834 -4461 111 7838 7836 7837 -4462 111 7841 7839 7840 -4463 111 7844 7842 7843 -4464 111 7847 7845 7846 -4465 111 7850 7848 7849 -4466 111 7853 7851 7852 -4467 111 7856 7854 7855 -4468 111 7859 7857 7858 -4469 111 7862 7860 7861 -4470 111 7865 7863 7864 -4471 111 7868 7866 7867 -4472 111 7871 7869 7870 -4473 111 7874 7872 7873 -4474 111 7877 7875 7876 -4475 111 7880 7878 7879 -4476 111 7883 7881 7882 -4477 111 7886 7884 7885 -4478 111 7889 7887 7888 -4479 111 7892 7890 7891 -4480 111 7895 7893 7894 -4481 111 7898 7896 7897 -4482 111 7901 7899 7900 -4483 111 7904 7902 7903 -4484 111 7907 7905 7906 -4485 111 7910 7908 7909 -4486 111 7913 7911 7912 -4487 111 7916 7914 7915 -4488 111 7919 7917 7918 -4489 111 7922 7920 7921 -4490 111 7925 7923 7924 -4491 111 7928 7926 7927 -4492 111 7931 7929 7930 -4493 111 7934 7932 7933 -4494 111 7937 7935 7936 -4495 111 7940 7938 7939 -4496 111 7943 7941 7942 -4497 111 7946 7944 7945 -4498 111 7949 7947 7948 -4499 111 7952 7950 7951 -4500 111 7955 7953 7954 -4501 111 7958 7956 7957 -4502 111 7961 7959 7960 -4503 111 7964 7962 7963 -4504 111 7967 7965 7966 -4505 111 7970 7968 7969 -4506 111 7973 7971 7972 -4507 111 7976 7974 7975 -4508 111 7979 7977 7978 -4509 111 7982 7980 7981 -4510 111 7985 7983 7984 -4511 111 7988 7986 7987 -4512 111 7991 7989 7990 -4513 111 7994 7992 7993 -4514 111 7997 7995 7996 -4515 111 8000 7998 7999 -4516 111 8003 8001 8002 -4517 111 8006 8004 8005 -4518 111 8009 8007 8008 -4519 111 8012 8010 8011 -4520 111 8015 8013 8014 -4521 111 8018 8016 8017 -4522 111 8021 8019 8020 -4523 111 8024 8022 8023 -4524 111 8027 8025 8026 -4525 111 8030 8028 8029 -4526 111 8033 8031 8032 -4527 111 8036 8034 8035 -4528 111 8039 8037 8038 -4529 111 8042 8040 8041 -4530 111 8045 8043 8044 -4531 111 8048 8046 8047 -4532 111 8051 8049 8050 -4533 111 8054 8052 8053 -4534 111 8057 8055 8056 -4535 111 8060 8058 8059 -4536 111 8063 8061 8062 -4537 111 8066 8064 8065 -4538 111 8069 8067 8068 -4539 111 8072 8070 8071 -4540 111 8075 8073 8074 -4541 111 8078 8076 8077 -4542 111 8081 8079 8080 -4543 111 8084 8082 8083 -4544 111 8087 8085 8086 -4545 111 8090 8088 8089 -4546 111 8093 8091 8092 -4547 111 8096 8094 8095 -4548 111 8099 8097 8098 -4549 111 8102 8100 8101 -4550 111 8105 8103 8104 -4551 111 8108 8106 8107 -4552 111 8111 8109 8110 -4553 111 8114 8112 8113 -4554 111 8117 8115 8116 -4555 111 8120 8118 8119 -4556 111 8123 8121 8122 -4557 111 8126 8124 8125 -4558 111 8129 8127 8128 -4559 111 8132 8130 8131 -4560 111 8135 8133 8134 -4561 111 8138 8136 8137 -4562 111 8141 8139 8140 -4563 111 8144 8142 8143 -4564 111 8147 8145 8146 -4565 111 8150 8148 8149 -4566 111 8153 8151 8152 -4567 111 8156 8154 8155 -4568 111 8159 8157 8158 -4569 111 8162 8160 8161 -4570 111 8165 8163 8164 -4571 111 8168 8166 8167 -4572 111 8171 8169 8170 -4573 111 8174 8172 8173 -4574 111 8177 8175 8176 -4575 111 8180 8178 8179 -4576 111 8183 8181 8182 -4577 111 8186 8184 8185 -4578 111 8189 8187 8188 -4579 111 8192 8190 8191 -4580 111 8195 8193 8194 -4581 111 8198 8196 8197 -4582 111 8201 8199 8200 -4583 111 8204 8202 8203 -4584 111 8207 8205 8206 -4585 111 8210 8208 8209 -4586 111 8213 8211 8212 -4587 111 8216 8214 8215 -4588 111 8219 8217 8218 -4589 111 8222 8220 8221 -4590 111 8225 8223 8224 -4591 111 8228 8226 8227 -4592 111 8231 8229 8230 -4593 111 8234 8232 8233 -4594 111 8237 8235 8236 -4595 111 8240 8238 8239 -4596 111 8243 8241 8242 -4597 111 8246 8244 8245 -4598 111 8249 8247 8248 -4599 111 8252 8250 8251 -4600 111 8255 8253 8254 -4601 111 8258 8256 8257 -4602 111 8261 8259 8260 -4603 111 8264 8262 8263 -4604 111 8267 8265 8266 -4605 111 8270 8268 8269 -4606 111 8273 8271 8272 -4607 111 8276 8274 8275 -4608 111 8279 8277 8278 -4609 111 8282 8280 8281 -4610 111 8285 8283 8284 -4611 111 8288 8286 8287 -4612 111 8291 8289 8290 -4613 111 8294 8292 8293 -4614 111 8297 8295 8296 -4615 111 8300 8298 8299 -4616 111 8303 8301 8302 -4617 111 8306 8304 8305 -4618 111 8309 8307 8308 -4619 111 8312 8310 8311 -4620 111 8315 8313 8314 -4621 111 8318 8316 8317 -4622 111 8321 8319 8320 -4623 111 8324 8322 8323 -4624 111 8327 8325 8326 -4625 111 8330 8328 8329 -4626 111 8333 8331 8332 -4627 111 8336 8334 8335 -4628 111 8339 8337 8338 -4629 111 8342 8340 8341 -4630 111 8345 8343 8344 -4631 111 8348 8346 8347 -4632 111 8351 8349 8350 -4633 111 8354 8352 8353 -4634 111 8357 8355 8356 -4635 111 8360 8358 8359 -4636 111 8363 8361 8362 -4637 111 8366 8364 8365 -4638 111 8369 8367 8368 -4639 111 8372 8370 8371 -4640 111 8375 8373 8374 -4641 111 8378 8376 8377 -4642 111 8381 8379 8380 -4643 111 8384 8382 8383 -4644 111 8387 8385 8386 -4645 111 8390 8388 8389 -4646 111 8393 8391 8392 -4647 111 8396 8394 8395 -4648 111 8399 8397 8398 -4649 111 8402 8400 8401 -4650 111 8405 8403 8404 -4651 111 8408 8406 8407 -4652 111 8411 8409 8410 -4653 111 8414 8412 8413 -4654 111 8417 8415 8416 -4655 111 8420 8418 8419 -4656 111 8423 8421 8422 -4657 111 8426 8424 8425 -4658 111 8429 8427 8428 -4659 111 8432 8430 8431 -4660 111 8435 8433 8434 -4661 111 8438 8436 8437 -4662 111 8441 8439 8440 -4663 111 8444 8442 8443 -4664 111 8447 8445 8446 -4665 111 8450 8448 8449 -4666 111 8453 8451 8452 -4667 111 8456 8454 8455 -4668 111 8459 8457 8458 -4669 111 8462 8460 8461 -4670 111 8465 8463 8464 -4671 111 8468 8466 8467 -4672 111 8471 8469 8470 -4673 111 8474 8472 8473 -4674 111 8477 8475 8476 -4675 111 8480 8478 8479 -4676 111 8483 8481 8482 -4677 111 8486 8484 8485 -4678 111 8489 8487 8488 -4679 111 8492 8490 8491 -4680 111 8495 8493 8494 -4681 111 8498 8496 8497 -4682 111 8501 8499 8500 -4683 111 8504 8502 8503 -4684 111 8507 8505 8506 -4685 111 8510 8508 8509 -4686 111 8513 8511 8512 -4687 111 8516 8514 8515 -4688 111 8519 8517 8518 -4689 111 8522 8520 8521 -4690 111 8525 8523 8524 -4691 111 8528 8526 8527 -4692 111 8531 8529 8530 -4693 111 8534 8532 8533 -4694 111 8537 8535 8536 -4695 111 8540 8538 8539 -4696 111 8543 8541 8542 -4697 111 8546 8544 8545 -4698 111 8549 8547 8548 -4699 111 8552 8550 8551 -4700 111 8555 8553 8554 -4701 111 8558 8556 8557 -4702 111 8561 8559 8560 -4703 111 8564 8562 8563 -4704 111 8567 8565 8566 -4705 111 8570 8568 8569 -4706 111 8573 8571 8572 -4707 111 8576 8574 8575 -4708 111 8579 8577 8578 -4709 111 8582 8580 8581 -4710 111 8585 8583 8584 -4711 111 8588 8586 8587 -4712 111 8591 8589 8590 -4713 111 8594 8592 8593 -4714 111 8597 8595 8596 -4715 111 8600 8598 8599 -4716 111 8603 8601 8602 -4717 111 8606 8604 8605 -4718 111 8609 8607 8608 -4719 111 8612 8610 8611 -4720 111 8615 8613 8614 -4721 111 8618 8616 8617 -4722 111 8621 8619 8620 -4723 111 8624 8622 8623 -4724 111 8627 8625 8626 -4725 111 8630 8628 8629 -4726 111 8633 8631 8632 -4727 111 8636 8634 8635 -4728 111 8639 8637 8638 -4729 111 8642 8640 8641 -4730 111 8645 8643 8644 -4731 111 8648 8646 8647 -4732 111 8651 8649 8650 -4733 111 8654 8652 8653 -4734 111 8657 8655 8656 -4735 111 8660 8658 8659 -4736 111 8663 8661 8662 -4737 111 8666 8664 8665 -4738 111 8669 8667 8668 -4739 111 8672 8670 8671 -4740 111 8675 8673 8674 -4741 111 8678 8676 8677 -4742 111 8681 8679 8680 -4743 111 8684 8682 8683 -4744 111 8687 8685 8686 -4745 111 8690 8688 8689 -4746 111 8693 8691 8692 -4747 111 8696 8694 8695 -4748 111 8699 8697 8698 -4749 111 8702 8700 8701 -4750 111 8705 8703 8704 -4751 111 8708 8706 8707 -4752 111 8711 8709 8710 -4753 111 8714 8712 8713 -4754 111 8717 8715 8716 -4755 111 8720 8718 8719 -4756 111 8723 8721 8722 -4757 111 8726 8724 8725 -4758 111 8729 8727 8728 -4759 111 8732 8730 8731 -4760 111 8735 8733 8734 -4761 111 8738 8736 8737 -4762 111 8741 8739 8740 -4763 111 8744 8742 8743 -4764 111 8747 8745 8746 -4765 111 8750 8748 8749 -4766 111 8753 8751 8752 -4767 111 8756 8754 8755 -4768 111 8759 8757 8758 -4769 111 8762 8760 8761 -4770 111 8765 8763 8764 -4771 111 8768 8766 8767 -4772 111 8771 8769 8770 -4773 111 8774 8772 8773 -4774 111 8777 8775 8776 -4775 111 8780 8778 8779 -4776 111 8783 8781 8782 -4777 111 8786 8784 8785 -4778 111 8789 8787 8788 -4779 111 8792 8790 8791 -4780 111 8795 8793 8794 -4781 111 8798 8796 8797 -4782 111 8801 8799 8800 -4783 111 8804 8802 8803 -4784 111 8807 8805 8806 -4785 111 8810 8808 8809 -4786 111 8813 8811 8812 -4787 111 8816 8814 8815 -4788 111 8819 8817 8818 -4789 111 8822 8820 8821 -4790 111 8825 8823 8824 -4791 111 8828 8826 8827 -4792 111 8831 8829 8830 -4793 111 8834 8832 8833 -4794 111 8837 8835 8836 -4795 111 8840 8838 8839 -4796 111 8843 8841 8842 -4797 111 8846 8844 8845 -4798 111 8849 8847 8848 -4799 111 8852 8850 8851 -4800 111 8855 8853 8854 -4801 111 8858 8856 8857 -4802 111 8861 8859 8860 -4803 111 8864 8862 8863 -4804 111 8867 8865 8866 -4805 111 8870 8868 8869 -4806 111 8873 8871 8872 -4807 111 8876 8874 8875 -4808 111 8879 8877 8878 -4809 111 8882 8880 8881 -4810 111 8885 8883 8884 -4811 111 8888 8886 8887 -4812 111 8891 8889 8890 -4813 111 8894 8892 8893 -4814 111 8897 8895 8896 -4815 111 8900 8898 8899 -4816 111 8903 8901 8902 -4817 111 8906 8904 8905 -4818 111 8909 8907 8908 -4819 111 8912 8910 8911 -4820 111 8915 8913 8914 -4821 111 8918 8916 8917 -4822 111 8921 8919 8920 -4823 111 8924 8922 8923 -4824 111 8927 8925 8926 -4825 111 8930 8928 8929 -4826 111 8933 8931 8932 -4827 111 8936 8934 8935 -4828 111 8939 8937 8938 -4829 111 8942 8940 8941 -4830 111 8945 8943 8944 -4831 111 8948 8946 8947 -4832 111 8951 8949 8950 -4833 111 8954 8952 8953 -4834 111 8957 8955 8956 -4835 111 8960 8958 8959 -4836 111 8963 8961 8962 -4837 111 8966 8964 8965 -4838 111 8969 8967 8968 -4839 111 8972 8970 8971 -4840 111 8975 8973 8974 -4841 111 8978 8976 8977 -4842 111 8981 8979 8980 -4843 111 8984 8982 8983 -4844 111 8987 8985 8986 -4845 111 8990 8988 8989 -4846 111 8993 8991 8992 -4847 111 8996 8994 8995 -4848 111 8999 8997 8998 -4849 111 9002 9000 9001 -4850 111 9005 9003 9004 -4851 111 9008 9006 9007 -4852 111 9011 9009 9010 -4853 111 9014 9012 9013 -4854 111 9017 9015 9016 -4855 111 9020 9018 9019 -4856 111 9023 9021 9022 -4857 111 9026 9024 9025 -4858 111 9029 9027 9028 -4859 111 9032 9030 9031 -4860 111 9035 9033 9034 -4861 111 9038 9036 9037 -4862 111 9041 9039 9040 -4863 111 9044 9042 9043 -4864 111 9047 9045 9046 -4865 111 9050 9048 9049 -4866 111 9053 9051 9052 -4867 111 9056 9054 9055 -4868 111 9059 9057 9058 -4869 111 9062 9060 9061 -4870 111 9065 9063 9064 -4871 111 9068 9066 9067 -4872 111 9071 9069 9070 -4873 111 9074 9072 9073 -4874 111 9077 9075 9076 -4875 111 9080 9078 9079 -4876 111 9083 9081 9082 -4877 111 9086 9084 9085 -4878 111 9089 9087 9088 -4879 111 9092 9090 9091 -4880 111 9095 9093 9094 -4881 111 9098 9096 9097 -4882 111 9101 9099 9100 -4883 111 9104 9102 9103 -4884 111 9107 9105 9106 -4885 111 9110 9108 9109 -4886 111 9113 9111 9112 -4887 111 9116 9114 9115 -4888 111 9119 9117 9118 -4889 111 9122 9120 9121 -4890 111 9125 9123 9124 -4891 111 9128 9126 9127 -4892 111 9131 9129 9130 -4893 111 9134 9132 9133 -4894 111 9137 9135 9136 -4895 111 9140 9138 9139 -4896 111 9143 9141 9142 -4897 111 9146 9144 9145 -4898 111 9149 9147 9148 -4899 111 9152 9150 9151 -4900 111 9155 9153 9154 -4901 111 9158 9156 9157 -4902 111 9161 9159 9160 -4903 111 9164 9162 9163 -4904 111 9167 9165 9166 -4905 111 9170 9168 9169 -4906 111 9173 9171 9172 -4907 111 9176 9174 9175 -4908 111 9179 9177 9178 -4909 111 9182 9180 9181 -4910 111 9185 9183 9184 -4911 111 9188 9186 9187 -4912 111 9191 9189 9190 -4913 111 9194 9192 9193 -4914 111 9197 9195 9196 -4915 111 9200 9198 9199 -4916 111 9203 9201 9202 -4917 111 9206 9204 9205 -4918 111 9209 9207 9208 -4919 111 9212 9210 9211 -4920 111 9215 9213 9214 -4921 111 9218 9216 9217 -4922 111 9221 9219 9220 -4923 111 9224 9222 9223 -4924 111 9227 9225 9226 -4925 111 9230 9228 9229 -4926 111 9233 9231 9232 -4927 111 9236 9234 9235 -4928 111 9239 9237 9238 -4929 111 9242 9240 9241 -4930 111 9245 9243 9244 -4931 111 9248 9246 9247 -4932 111 9251 9249 9250 -4933 111 9254 9252 9253 -4934 111 9257 9255 9256 -4935 111 9260 9258 9259 -4936 111 9263 9261 9262 -4937 111 9266 9264 9265 -4938 111 9269 9267 9268 -4939 111 9272 9270 9271 -4940 111 9275 9273 9274 -4941 111 9278 9276 9277 -4942 111 9281 9279 9280 -4943 111 9284 9282 9283 -4944 111 9287 9285 9286 -4945 111 9290 9288 9289 -4946 111 9293 9291 9292 -4947 111 9296 9294 9295 -4948 111 9299 9297 9298 -4949 111 9302 9300 9301 -4950 111 9305 9303 9304 -4951 111 9308 9306 9307 -4952 111 9311 9309 9310 -4953 111 9314 9312 9313 -4954 111 9317 9315 9316 -4955 111 9320 9318 9319 -4956 111 9323 9321 9322 -4957 111 9326 9324 9325 -4958 111 9329 9327 9328 -4959 111 9332 9330 9331 -4960 111 9335 9333 9334 -4961 111 9338 9336 9337 -4962 111 9341 9339 9340 -4963 111 9344 9342 9343 -4964 111 9347 9345 9346 -4965 111 9350 9348 9349 -4966 111 9353 9351 9352 -4967 111 9356 9354 9355 -4968 111 9359 9357 9358 -4969 111 9362 9360 9361 -4970 111 9365 9363 9364 -4971 111 9368 9366 9367 -4972 111 9371 9369 9370 -4973 111 9374 9372 9373 -4974 111 9377 9375 9376 -4975 111 9380 9378 9379 -4976 111 9383 9381 9382 -4977 111 9386 9384 9385 -4978 111 9389 9387 9388 -4979 111 9392 9390 9391 -4980 111 9395 9393 9394 -4981 111 9398 9396 9397 -4982 111 9401 9399 9400 -4983 111 9404 9402 9403 -4984 111 9407 9405 9406 -4985 111 9410 9408 9409 -4986 111 9413 9411 9412 -4987 111 9416 9414 9415 -4988 111 9419 9417 9418 -4989 111 9422 9420 9421 -4990 111 9425 9423 9424 -4991 111 9428 9426 9427 -4992 111 9431 9429 9430 -4993 111 9434 9432 9433 -4994 111 9437 9435 9436 -4995 111 9440 9438 9439 -4996 111 9443 9441 9442 -4997 111 9446 9444 9445 -4998 111 9449 9447 9448 -4999 111 9452 9450 9451 -5000 111 9455 9453 9454 -5001 111 9458 9456 9457 -5002 111 9461 9459 9460 -5003 111 9464 9462 9463 -5004 111 9467 9465 9466 -5005 111 9470 9468 9469 -5006 111 9473 9471 9472 -5007 111 9476 9474 9475 -5008 111 9479 9477 9478 -5009 111 9482 9480 9481 -5010 111 9485 9483 9484 -5011 111 9488 9486 9487 -5012 111 9491 9489 9490 -5013 111 9494 9492 9493 -5014 111 9497 9495 9496 -5015 111 9500 9498 9499 -5016 111 9503 9501 9502 -5017 111 9506 9504 9505 -5018 111 9509 9507 9508 -5019 111 9512 9510 9511 -5020 111 9515 9513 9514 -5021 111 9518 9516 9517 -5022 111 9521 9519 9520 -5023 111 9524 9522 9523 -5024 111 9527 9525 9526 -5025 111 9530 9528 9529 -5026 111 9533 9531 9532 -5027 111 9536 9534 9535 -5028 111 9539 9537 9538 -5029 111 9542 9540 9541 -5030 111 9545 9543 9544 -5031 111 9548 9546 9547 -5032 111 9551 9549 9550 -5033 111 9554 9552 9553 -5034 111 9557 9555 9556 -5035 111 9560 9558 9559 -5036 111 9563 9561 9562 -5037 111 9566 9564 9565 -5038 111 9569 9567 9568 -5039 111 9572 9570 9571 -5040 111 9575 9573 9574 -5041 111 9578 9576 9577 -5042 111 9581 9579 9580 -5043 111 9584 9582 9583 -5044 111 9587 9585 9586 -5045 111 9590 9588 9589 -5046 111 9593 9591 9592 -5047 111 9596 9594 9595 -5048 111 9599 9597 9598 -5049 111 9602 9600 9601 -5050 111 9605 9603 9604 -5051 111 9608 9606 9607 -5052 111 9611 9609 9610 -5053 111 9614 9612 9613 -5054 111 9617 9615 9616 -5055 111 9620 9618 9619 -5056 111 9623 9621 9622 -5057 111 9626 9624 9625 -5058 111 9629 9627 9628 -5059 111 9632 9630 9631 -5060 111 9635 9633 9634 -5061 111 9638 9636 9637 -5062 111 9641 9639 9640 -5063 111 9644 9642 9643 -5064 111 9647 9645 9646 -5065 111 9650 9648 9649 -5066 111 9653 9651 9652 -5067 111 9656 9654 9655 -5068 111 9659 9657 9658 -5069 111 9662 9660 9661 -5070 111 9665 9663 9664 -5071 111 9668 9666 9667 -5072 111 9671 9669 9670 -5073 111 9674 9672 9673 -5074 111 9677 9675 9676 -5075 111 9680 9678 9679 -5076 111 9683 9681 9682 -5077 111 9686 9684 9685 -5078 111 9689 9687 9688 -5079 111 9692 9690 9691 -5080 111 9695 9693 9694 -5081 111 9698 9696 9697 -5082 111 9701 9699 9700 -5083 111 9704 9702 9703 -5084 111 9707 9705 9706 -5085 111 9710 9708 9709 -5086 111 9713 9711 9712 -5087 111 9716 9714 9715 -5088 111 9719 9717 9718 -5089 111 9722 9720 9721 -5090 111 9725 9723 9724 -5091 111 9728 9726 9727 -5092 111 9731 9729 9730 -5093 111 9734 9732 9733 -5094 111 9737 9735 9736 +2259 62 1228 1227 1232 +2260 111 1234 1233 1235 +2261 111 1237 1236 1238 +2262 111 1240 1239 1241 +2263 111 1243 1242 1244 +2264 111 1246 1245 1247 +2265 111 1249 1248 1250 +2266 111 1252 1251 1253 +2267 111 1255 1254 1256 +2268 111 1258 1257 1259 +2269 111 1261 1260 1262 +2270 111 1264 1263 1265 +2271 111 1267 1266 1268 +2272 111 1270 1269 1271 +2273 111 1273 1272 1274 +2274 111 1276 1275 1277 +2275 111 1279 1278 1280 +2276 111 1282 1281 1283 +2277 111 1285 1284 1286 +2278 111 1288 1287 1289 +2279 111 1291 1290 1292 +2280 111 1294 1293 1295 +2281 111 1297 1296 1298 +2282 111 1300 1299 1301 +2283 111 1303 1302 1304 +2284 111 1306 1305 1307 +2285 111 1309 1308 1310 +2286 111 1312 1311 1313 +2287 111 1315 1314 1316 +2288 111 1318 1317 1319 +2289 111 1321 1320 1322 +2290 111 1324 1323 1325 +2291 111 1327 1326 1328 +2292 111 1330 1329 1331 +2293 111 1333 1332 1334 +2294 111 1336 1335 1337 +2295 111 1339 1338 1340 +2296 111 1342 1341 1343 +2297 111 1345 1344 1346 +2298 111 1348 1347 1349 +2299 111 1351 1350 1352 +2300 111 1354 1353 1355 +2301 111 1357 1356 1358 +2302 111 1360 1359 1361 +2303 111 1363 1362 1364 +2304 111 1366 1365 1367 +2305 111 1369 1368 1370 +2306 111 1372 1371 1373 +2307 111 1375 1374 1376 +2308 111 1378 1377 1379 +2309 111 1381 1380 1382 +2310 111 1384 1383 1385 +2311 111 1387 1386 1388 +2312 111 1390 1389 1391 +2313 111 1393 1392 1394 +2314 111 1396 1395 1397 +2315 111 1399 1398 1400 +2316 111 1402 1401 1403 +2317 111 1405 1404 1406 +2318 111 1408 1407 1409 +2319 111 1411 1410 1412 +2320 111 1414 1413 1415 +2321 111 1417 1416 1418 +2322 111 1420 1419 1421 +2323 111 1423 1422 1424 +2324 111 1426 1425 1427 +2325 111 1429 1428 1430 +2326 111 1432 1431 1433 +2327 111 1435 1434 1436 +2328 111 1438 1437 1439 +2329 111 1441 1440 1442 +2330 111 1444 1443 1445 +2331 111 1447 1446 1448 +2332 111 1450 1449 1451 +2333 111 1453 1452 1454 +2334 111 1456 1455 1457 +2335 111 1459 1458 1460 +2336 111 1462 1461 1463 +2337 111 1465 1464 1466 +2338 111 1468 1467 1469 +2339 111 1471 1470 1472 +2340 111 1474 1473 1475 +2341 111 1477 1476 1478 +2342 111 1480 1479 1481 +2343 111 1483 1482 1484 +2344 111 1486 1485 1487 +2345 111 1489 1488 1490 +2346 111 1492 1491 1493 +2347 111 1495 1494 1496 +2348 111 1498 1497 1499 +2349 111 1501 1500 1502 +2350 111 1504 1503 1505 +2351 111 1507 1506 1508 +2352 111 1510 1509 1511 +2353 111 1513 1512 1514 +2354 111 1516 1515 1517 +2355 111 1519 1518 1520 +2356 111 1522 1521 1523 +2357 111 1525 1524 1526 +2358 111 1528 1527 1529 +2359 111 1531 1530 1532 +2360 111 1534 1533 1535 +2361 111 1537 1536 1538 +2362 111 1540 1539 1541 +2363 111 1543 1542 1544 +2364 111 1546 1545 1547 +2365 111 1549 1548 1550 +2366 111 1552 1551 1553 +2367 111 1555 1554 1556 +2368 111 1558 1557 1559 +2369 111 1561 1560 1562 +2370 111 1564 1563 1565 +2371 111 1567 1566 1568 +2372 111 1570 1569 1571 +2373 111 1573 1572 1574 +2374 111 1576 1575 1577 +2375 111 1579 1578 1580 +2376 111 1582 1581 1583 +2377 111 1585 1584 1586 +2378 111 1588 1587 1589 +2379 111 1591 1590 1592 +2380 111 1594 1593 1595 +2381 111 1597 1596 1598 +2382 111 1600 1599 1601 +2383 111 1603 1602 1604 +2384 111 1606 1605 1607 +2385 111 1609 1608 1610 +2386 111 1612 1611 1613 +2387 111 1615 1614 1616 +2388 111 1618 1617 1619 +2389 111 1621 1620 1622 +2390 111 1624 1623 1625 +2391 111 1627 1626 1628 +2392 111 1630 1629 1631 +2393 111 1633 1632 1634 +2394 111 1636 1635 1637 +2395 111 1639 1638 1640 +2396 111 1642 1641 1643 +2397 111 1645 1644 1646 +2398 111 1648 1647 1649 +2399 111 1651 1650 1652 +2400 111 1654 1653 1655 +2401 111 1657 1656 1658 +2402 111 1660 1659 1661 +2403 111 1663 1662 1664 +2404 111 1666 1665 1667 +2405 111 1669 1668 1670 +2406 111 1672 1671 1673 +2407 111 1675 1674 1676 +2408 111 1678 1677 1679 +2409 111 1681 1680 1682 +2410 111 1684 1683 1685 +2411 111 1687 1686 1688 +2412 111 1690 1689 1691 +2413 111 1693 1692 1694 +2414 111 1696 1695 1697 +2415 111 1699 1698 1700 +2416 111 1702 1701 1703 +2417 111 1705 1704 1706 +2418 111 1708 1707 1709 +2419 111 1711 1710 1712 +2420 111 1714 1713 1715 +2421 111 1717 1716 1718 +2422 111 1720 1719 1721 +2423 111 1723 1722 1724 +2424 111 1726 1725 1727 +2425 111 1729 1728 1730 +2426 111 1732 1731 1733 +2427 111 1735 1734 1736 +2428 111 1738 1737 1739 +2429 111 1741 1740 1742 +2430 111 1744 1743 1745 +2431 111 1747 1746 1748 +2432 111 1750 1749 1751 +2433 111 1753 1752 1754 +2434 111 1756 1755 1757 +2435 111 1759 1758 1760 +2436 111 1762 1761 1763 +2437 111 1765 1764 1766 +2438 111 1768 1767 1769 +2439 111 1771 1770 1772 +2440 111 1774 1773 1775 +2441 111 1777 1776 1778 +2442 111 1780 1779 1781 +2443 111 1783 1782 1784 +2444 111 1786 1785 1787 +2445 111 1789 1788 1790 +2446 111 1792 1791 1793 +2447 111 1795 1794 1796 +2448 111 1798 1797 1799 +2449 111 1801 1800 1802 +2450 111 1804 1803 1805 +2451 111 1807 1806 1808 +2452 111 1810 1809 1811 +2453 111 1813 1812 1814 +2454 111 1816 1815 1817 +2455 111 1819 1818 1820 +2456 111 1822 1821 1823 +2457 111 1825 1824 1826 +2458 111 1828 1827 1829 +2459 111 1831 1830 1832 +2460 111 1834 1833 1835 +2461 111 1837 1836 1838 +2462 111 1840 1839 1841 +2463 111 1843 1842 1844 +2464 111 1846 1845 1847 +2465 111 1849 1848 1850 +2466 111 1852 1851 1853 +2467 111 1855 1854 1856 +2468 111 1858 1857 1859 +2469 111 1861 1860 1862 +2470 111 1864 1863 1865 +2471 111 1867 1866 1868 +2472 111 1870 1869 1871 +2473 111 1873 1872 1874 +2474 111 1876 1875 1877 +2475 111 1879 1878 1880 +2476 111 1882 1881 1883 +2477 111 1885 1884 1886 +2478 111 1888 1887 1889 +2479 111 1891 1890 1892 +2480 111 1894 1893 1895 +2481 111 1897 1896 1898 +2482 111 1900 1899 1901 +2483 111 1903 1902 1904 +2484 111 1906 1905 1907 +2485 111 1909 1908 1910 +2486 111 1912 1911 1913 +2487 111 1915 1914 1916 +2488 111 1918 1917 1919 +2489 111 1921 1920 1922 +2490 111 1924 1923 1925 +2491 111 1927 1926 1928 +2492 111 1930 1929 1931 +2493 111 1933 1932 1934 +2494 111 1936 1935 1937 +2495 111 1939 1938 1940 +2496 111 1942 1941 1943 +2497 111 1945 1944 1946 +2498 111 1948 1947 1949 +2499 111 1951 1950 1952 +2500 111 1954 1953 1955 +2501 111 1957 1956 1958 +2502 111 1960 1959 1961 +2503 111 1963 1962 1964 +2504 111 1966 1965 1967 +2505 111 1969 1968 1970 +2506 111 1972 1971 1973 +2507 111 1975 1974 1976 +2508 111 1978 1977 1979 +2509 111 1981 1980 1982 +2510 111 1984 1983 1985 +2511 111 1987 1986 1988 +2512 111 1990 1989 1991 +2513 111 1993 1992 1994 +2514 111 1996 1995 1997 +2515 111 1999 1998 2000 +2516 111 2002 2001 2003 +2517 111 2005 2004 2006 +2518 111 2008 2007 2009 +2519 111 2011 2010 2012 +2520 111 2014 2013 2015 +2521 111 2017 2016 2018 +2522 111 2020 2019 2021 +2523 111 2023 2022 2024 +2524 111 2026 2025 2027 +2525 111 2029 2028 2030 +2526 111 2032 2031 2033 +2527 111 2035 2034 2036 +2528 111 2038 2037 2039 +2529 111 2041 2040 2042 +2530 111 2044 2043 2045 +2531 111 2047 2046 2048 +2532 111 2050 2049 2051 +2533 111 2053 2052 2054 +2534 111 2056 2055 2057 +2535 111 2059 2058 2060 +2536 111 2062 2061 2063 +2537 111 2065 2064 2066 +2538 111 2068 2067 2069 +2539 111 2071 2070 2072 +2540 111 2074 2073 2075 +2541 111 2077 2076 2078 +2542 111 2080 2079 2081 +2543 111 2083 2082 2084 +2544 111 2086 2085 2087 +2545 111 2089 2088 2090 +2546 111 2092 2091 2093 +2547 111 2095 2094 2096 +2548 111 2098 2097 2099 +2549 111 2101 2100 2102 +2550 111 2104 2103 2105 +2551 111 2107 2106 2108 +2552 111 2110 2109 2111 +2553 111 2113 2112 2114 +2554 111 2116 2115 2117 +2555 111 2119 2118 2120 +2556 111 2122 2121 2123 +2557 111 2125 2124 2126 +2558 111 2128 2127 2129 +2559 111 2131 2130 2132 +2560 111 2134 2133 2135 +2561 111 2137 2136 2138 +2562 111 2140 2139 2141 +2563 111 2143 2142 2144 +2564 111 2146 2145 2147 +2565 111 2149 2148 2150 +2566 111 2152 2151 2153 +2567 111 2155 2154 2156 +2568 111 2158 2157 2159 +2569 111 2161 2160 2162 +2570 111 2164 2163 2165 +2571 111 2167 2166 2168 +2572 111 2170 2169 2171 +2573 111 2173 2172 2174 +2574 111 2176 2175 2177 +2575 111 2179 2178 2180 +2576 111 2182 2181 2183 +2577 111 2185 2184 2186 +2578 111 2188 2187 2189 +2579 111 2191 2190 2192 +2580 111 2194 2193 2195 +2581 111 2197 2196 2198 +2582 111 2200 2199 2201 +2583 111 2203 2202 2204 +2584 111 2206 2205 2207 +2585 111 2209 2208 2210 +2586 111 2212 2211 2213 +2587 111 2215 2214 2216 +2588 111 2218 2217 2219 +2589 111 2221 2220 2222 +2590 111 2224 2223 2225 +2591 111 2227 2226 2228 +2592 111 2230 2229 2231 +2593 111 2233 2232 2234 +2594 111 2236 2235 2237 +2595 111 2239 2238 2240 +2596 111 2242 2241 2243 +2597 111 2245 2244 2246 +2598 111 2248 2247 2249 +2599 111 2251 2250 2252 +2600 111 2254 2253 2255 +2601 111 2257 2256 2258 +2602 111 2260 2259 2261 +2603 111 2263 2262 2264 +2604 111 2266 2265 2267 +2605 111 2269 2268 2270 +2606 111 2272 2271 2273 +2607 111 2275 2274 2276 +2608 111 2278 2277 2279 +2609 111 2281 2280 2282 +2610 111 2284 2283 2285 +2611 111 2287 2286 2288 +2612 111 2290 2289 2291 +2613 111 2293 2292 2294 +2614 111 2296 2295 2297 +2615 111 2299 2298 2300 +2616 111 2302 2301 2303 +2617 111 2305 2304 2306 +2618 111 2308 2307 2309 +2619 111 2311 2310 2312 +2620 111 2314 2313 2315 +2621 111 2317 2316 2318 +2622 111 2320 2319 2321 +2623 111 2323 2322 2324 +2624 111 2326 2325 2327 +2625 111 2329 2328 2330 +2626 111 2332 2331 2333 +2627 111 2335 2334 2336 +2628 111 2338 2337 2339 +2629 111 2341 2340 2342 +2630 111 2344 2343 2345 +2631 111 2347 2346 2348 +2632 111 2350 2349 2351 +2633 111 2353 2352 2354 +2634 111 2356 2355 2357 +2635 111 2359 2358 2360 +2636 111 2362 2361 2363 +2637 111 2365 2364 2366 +2638 111 2368 2367 2369 +2639 111 2371 2370 2372 +2640 111 2374 2373 2375 +2641 111 2377 2376 2378 +2642 111 2380 2379 2381 +2643 111 2383 2382 2384 +2644 111 2386 2385 2387 +2645 111 2389 2388 2390 +2646 111 2392 2391 2393 +2647 111 2395 2394 2396 +2648 111 2398 2397 2399 +2649 111 2401 2400 2402 +2650 111 2404 2403 2405 +2651 111 2407 2406 2408 +2652 111 2410 2409 2411 +2653 111 2413 2412 2414 +2654 111 2416 2415 2417 +2655 111 2419 2418 2420 +2656 111 2422 2421 2423 +2657 111 2425 2424 2426 +2658 111 2428 2427 2429 +2659 111 2431 2430 2432 +2660 111 2434 2433 2435 +2661 111 2437 2436 2438 +2662 111 2440 2439 2441 +2663 111 2443 2442 2444 +2664 111 2446 2445 2447 +2665 111 2449 2448 2450 +2666 111 2452 2451 2453 +2667 111 2455 2454 2456 +2668 111 2458 2457 2459 +2669 111 2461 2460 2462 +2670 111 2464 2463 2465 +2671 111 2467 2466 2468 +2672 111 2470 2469 2471 +2673 111 2473 2472 2474 +2674 111 2476 2475 2477 +2675 111 2479 2478 2480 +2676 111 2482 2481 2483 +2677 111 2485 2484 2486 +2678 111 2488 2487 2489 +2679 111 2491 2490 2492 +2680 111 2494 2493 2495 +2681 111 2497 2496 2498 +2682 111 2500 2499 2501 +2683 111 2503 2502 2504 +2684 111 2506 2505 2507 +2685 111 2509 2508 2510 +2686 111 2512 2511 2513 +2687 111 2515 2514 2516 +2688 111 2518 2517 2519 +2689 111 2521 2520 2522 +2690 111 2524 2523 2525 +2691 111 2527 2526 2528 +2692 111 2530 2529 2531 +2693 111 2533 2532 2534 +2694 111 2536 2535 2537 +2695 111 2539 2538 2540 +2696 111 2542 2541 2543 +2697 111 2545 2544 2546 +2698 111 2548 2547 2549 +2699 111 2551 2550 2552 +2700 111 2554 2553 2555 +2701 111 2557 2556 2558 +2702 111 2560 2559 2561 +2703 111 2563 2562 2564 +2704 111 2566 2565 2567 +2705 111 2569 2568 2570 +2706 111 2572 2571 2573 +2707 111 2575 2574 2576 +2708 111 2578 2577 2579 +2709 111 2581 2580 2582 +2710 111 2584 2583 2585 +2711 111 2587 2586 2588 +2712 111 2590 2589 2591 +2713 111 2593 2592 2594 +2714 111 2596 2595 2597 +2715 111 2599 2598 2600 +2716 111 2602 2601 2603 +2717 111 2605 2604 2606 +2718 111 2608 2607 2609 +2719 111 2611 2610 2612 +2720 111 2614 2613 2615 +2721 111 2617 2616 2618 +2722 111 2620 2619 2621 +2723 111 2623 2622 2624 +2724 111 2626 2625 2627 +2725 111 2629 2628 2630 +2726 111 2632 2631 2633 +2727 111 2635 2634 2636 +2728 111 2638 2637 2639 +2729 111 2641 2640 2642 +2730 111 2644 2643 2645 +2731 111 2647 2646 2648 +2732 111 2650 2649 2651 +2733 111 2653 2652 2654 +2734 111 2656 2655 2657 +2735 111 2659 2658 2660 +2736 111 2662 2661 2663 +2737 111 2665 2664 2666 +2738 111 2668 2667 2669 +2739 111 2671 2670 2672 +2740 111 2674 2673 2675 +2741 111 2677 2676 2678 +2742 111 2680 2679 2681 +2743 111 2683 2682 2684 +2744 111 2686 2685 2687 +2745 111 2689 2688 2690 +2746 111 2692 2691 2693 +2747 111 2695 2694 2696 +2748 111 2698 2697 2699 +2749 111 2701 2700 2702 +2750 111 2704 2703 2705 +2751 111 2707 2706 2708 +2752 111 2710 2709 2711 +2753 111 2713 2712 2714 +2754 111 2716 2715 2717 +2755 111 2719 2718 2720 +2756 111 2722 2721 2723 +2757 111 2725 2724 2726 +2758 111 2728 2727 2729 +2759 111 2731 2730 2732 +2760 111 2734 2733 2735 +2761 111 2737 2736 2738 +2762 111 2740 2739 2741 +2763 111 2743 2742 2744 +2764 111 2746 2745 2747 +2765 111 2749 2748 2750 +2766 111 2752 2751 2753 +2767 111 2755 2754 2756 +2768 111 2758 2757 2759 +2769 111 2761 2760 2762 +2770 111 2764 2763 2765 +2771 111 2767 2766 2768 +2772 111 2770 2769 2771 +2773 111 2773 2772 2774 +2774 111 2776 2775 2777 +2775 111 2779 2778 2780 +2776 111 2782 2781 2783 +2777 111 2785 2784 2786 +2778 111 2788 2787 2789 +2779 111 2791 2790 2792 +2780 111 2794 2793 2795 +2781 111 2797 2796 2798 +2782 111 2800 2799 2801 +2783 111 2803 2802 2804 +2784 111 2806 2805 2807 +2785 111 2809 2808 2810 +2786 111 2812 2811 2813 +2787 111 2815 2814 2816 +2788 111 2818 2817 2819 +2789 111 2821 2820 2822 +2790 111 2824 2823 2825 +2791 111 2827 2826 2828 +2792 111 2830 2829 2831 +2793 111 2833 2832 2834 +2794 111 2836 2835 2837 +2795 111 2839 2838 2840 +2796 111 2842 2841 2843 +2797 111 2845 2844 2846 +2798 111 2848 2847 2849 +2799 111 2851 2850 2852 +2800 111 2854 2853 2855 +2801 111 2857 2856 2858 +2802 111 2860 2859 2861 +2803 111 2863 2862 2864 +2804 111 2866 2865 2867 +2805 111 2869 2868 2870 +2806 111 2872 2871 2873 +2807 111 2875 2874 2876 +2808 111 2878 2877 2879 +2809 111 2881 2880 2882 +2810 111 2884 2883 2885 +2811 111 2887 2886 2888 +2812 111 2890 2889 2891 +2813 111 2893 2892 2894 +2814 111 2896 2895 2897 +2815 111 2899 2898 2900 +2816 111 2902 2901 2903 +2817 111 2905 2904 2906 +2818 111 2908 2907 2909 +2819 111 2911 2910 2912 +2820 111 2914 2913 2915 +2821 111 2917 2916 2918 +2822 111 2920 2919 2921 +2823 111 2923 2922 2924 +2824 111 2926 2925 2927 +2825 111 2929 2928 2930 +2826 111 2932 2931 2933 +2827 111 2935 2934 2936 +2828 111 2938 2937 2939 +2829 111 2941 2940 2942 +2830 111 2944 2943 2945 +2831 111 2947 2946 2948 +2832 111 2950 2949 2951 +2833 111 2953 2952 2954 +2834 111 2956 2955 2957 +2835 111 2959 2958 2960 +2836 111 2962 2961 2963 +2837 111 2965 2964 2966 +2838 111 2968 2967 2969 +2839 111 2971 2970 2972 +2840 111 2974 2973 2975 +2841 111 2977 2976 2978 +2842 111 2980 2979 2981 +2843 111 2983 2982 2984 +2844 111 2986 2985 2987 +2845 111 2989 2988 2990 +2846 111 2992 2991 2993 +2847 111 2995 2994 2996 +2848 111 2998 2997 2999 +2849 111 3001 3000 3002 +2850 111 3004 3003 3005 +2851 111 3007 3006 3008 +2852 111 3010 3009 3011 +2853 111 3013 3012 3014 +2854 111 3016 3015 3017 +2855 111 3019 3018 3020 +2856 111 3022 3021 3023 +2857 111 3025 3024 3026 +2858 111 3028 3027 3029 +2859 111 3031 3030 3032 +2860 111 3034 3033 3035 +2861 111 3037 3036 3038 +2862 111 3040 3039 3041 +2863 111 3043 3042 3044 +2864 111 3046 3045 3047 +2865 111 3049 3048 3050 +2866 111 3052 3051 3053 +2867 111 3055 3054 3056 +2868 111 3058 3057 3059 +2869 111 3061 3060 3062 +2870 111 3064 3063 3065 +2871 111 3067 3066 3068 +2872 111 3070 3069 3071 +2873 111 3073 3072 3074 +2874 111 3076 3075 3077 +2875 111 3079 3078 3080 +2876 111 3082 3081 3083 +2877 111 3085 3084 3086 +2878 111 3088 3087 3089 +2879 111 3091 3090 3092 +2880 111 3094 3093 3095 +2881 111 3097 3096 3098 +2882 111 3100 3099 3101 +2883 111 3103 3102 3104 +2884 111 3106 3105 3107 +2885 111 3109 3108 3110 +2886 111 3112 3111 3113 +2887 111 3115 3114 3116 +2888 111 3118 3117 3119 +2889 111 3121 3120 3122 +2890 111 3124 3123 3125 +2891 111 3127 3126 3128 +2892 111 3130 3129 3131 +2893 111 3133 3132 3134 +2894 111 3136 3135 3137 +2895 111 3139 3138 3140 +2896 111 3142 3141 3143 +2897 111 3145 3144 3146 +2898 111 3148 3147 3149 +2899 111 3151 3150 3152 +2900 111 3154 3153 3155 +2901 111 3157 3156 3158 +2902 111 3160 3159 3161 +2903 111 3163 3162 3164 +2904 111 3166 3165 3167 +2905 111 3169 3168 3170 +2906 111 3172 3171 3173 +2907 111 3175 3174 3176 +2908 111 3178 3177 3179 +2909 111 3181 3180 3182 +2910 111 3184 3183 3185 +2911 111 3187 3186 3188 +2912 111 3190 3189 3191 +2913 111 3193 3192 3194 +2914 111 3196 3195 3197 +2915 111 3199 3198 3200 +2916 111 3202 3201 3203 +2917 111 3205 3204 3206 +2918 111 3208 3207 3209 +2919 111 3211 3210 3212 +2920 111 3214 3213 3215 +2921 111 3217 3216 3218 +2922 111 3220 3219 3221 +2923 111 3223 3222 3224 +2924 111 3226 3225 3227 +2925 111 3229 3228 3230 +2926 111 3232 3231 3233 +2927 111 3235 3234 3236 +2928 111 3238 3237 3239 +2929 111 3241 3240 3242 +2930 111 3244 3243 3245 +2931 111 3247 3246 3248 +2932 111 3250 3249 3251 +2933 111 3253 3252 3254 +2934 111 3256 3255 3257 +2935 111 3259 3258 3260 +2936 111 3262 3261 3263 +2937 111 3265 3264 3266 +2938 111 3268 3267 3269 +2939 111 3271 3270 3272 +2940 111 3274 3273 3275 +2941 111 3277 3276 3278 +2942 111 3280 3279 3281 +2943 111 3283 3282 3284 +2944 111 3286 3285 3287 +2945 111 3289 3288 3290 +2946 111 3292 3291 3293 +2947 111 3295 3294 3296 +2948 111 3298 3297 3299 +2949 111 3301 3300 3302 +2950 111 3304 3303 3305 +2951 111 3307 3306 3308 +2952 111 3310 3309 3311 +2953 111 3313 3312 3314 +2954 111 3316 3315 3317 +2955 111 3319 3318 3320 +2956 111 3322 3321 3323 +2957 111 3325 3324 3326 +2958 111 3328 3327 3329 +2959 111 3331 3330 3332 +2960 111 3334 3333 3335 +2961 111 3337 3336 3338 +2962 111 3340 3339 3341 +2963 111 3343 3342 3344 +2964 111 3346 3345 3347 +2965 111 3349 3348 3350 +2966 111 3352 3351 3353 +2967 111 3355 3354 3356 +2968 111 3358 3357 3359 +2969 111 3361 3360 3362 +2970 111 3364 3363 3365 +2971 111 3367 3366 3368 +2972 111 3370 3369 3371 +2973 111 3373 3372 3374 +2974 111 3376 3375 3377 +2975 111 3379 3378 3380 +2976 111 3382 3381 3383 +2977 111 3385 3384 3386 +2978 111 3388 3387 3389 +2979 111 3391 3390 3392 +2980 111 3394 3393 3395 +2981 111 3397 3396 3398 +2982 111 3400 3399 3401 +2983 111 3403 3402 3404 +2984 111 3406 3405 3407 +2985 111 3409 3408 3410 +2986 111 3412 3411 3413 +2987 111 3415 3414 3416 +2988 111 3418 3417 3419 +2989 111 3421 3420 3422 +2990 111 3424 3423 3425 +2991 111 3427 3426 3428 +2992 111 3430 3429 3431 +2993 111 3433 3432 3434 +2994 111 3436 3435 3437 +2995 111 3439 3438 3440 +2996 111 3442 3441 3443 +2997 111 3445 3444 3446 +2998 111 3448 3447 3449 +2999 111 3451 3450 3452 +3000 111 3454 3453 3455 +3001 111 3457 3456 3458 +3002 111 3460 3459 3461 +3003 111 3463 3462 3464 +3004 111 3466 3465 3467 +3005 111 3469 3468 3470 +3006 111 3472 3471 3473 +3007 111 3475 3474 3476 +3008 111 3478 3477 3479 +3009 111 3481 3480 3482 +3010 111 3484 3483 3485 +3011 111 3487 3486 3488 +3012 111 3490 3489 3491 +3013 111 3493 3492 3494 +3014 111 3496 3495 3497 +3015 111 3499 3498 3500 +3016 111 3502 3501 3503 +3017 111 3505 3504 3506 +3018 111 3508 3507 3509 +3019 111 3511 3510 3512 +3020 111 3514 3513 3515 +3021 111 3517 3516 3518 +3022 111 3520 3519 3521 +3023 111 3523 3522 3524 +3024 111 3526 3525 3527 +3025 111 3529 3528 3530 +3026 111 3532 3531 3533 +3027 111 3535 3534 3536 +3028 111 3538 3537 3539 +3029 111 3541 3540 3542 +3030 111 3544 3543 3545 +3031 111 3547 3546 3548 +3032 111 3550 3549 3551 +3033 111 3553 3552 3554 +3034 111 3556 3555 3557 +3035 111 3559 3558 3560 +3036 111 3562 3561 3563 +3037 111 3565 3564 3566 +3038 111 3568 3567 3569 +3039 111 3571 3570 3572 +3040 111 3574 3573 3575 +3041 111 3577 3576 3578 +3042 111 3580 3579 3581 +3043 111 3583 3582 3584 +3044 111 3586 3585 3587 +3045 111 3589 3588 3590 +3046 111 3592 3591 3593 +3047 111 3595 3594 3596 +3048 111 3598 3597 3599 +3049 111 3601 3600 3602 +3050 111 3604 3603 3605 +3051 111 3607 3606 3608 +3052 111 3610 3609 3611 +3053 111 3613 3612 3614 +3054 111 3616 3615 3617 +3055 111 3619 3618 3620 +3056 111 3622 3621 3623 +3057 111 3625 3624 3626 +3058 111 3628 3627 3629 +3059 111 3631 3630 3632 +3060 111 3634 3633 3635 +3061 111 3637 3636 3638 +3062 111 3640 3639 3641 +3063 111 3643 3642 3644 +3064 111 3646 3645 3647 +3065 111 3649 3648 3650 +3066 111 3652 3651 3653 +3067 111 3655 3654 3656 +3068 111 3658 3657 3659 +3069 111 3661 3660 3662 +3070 111 3664 3663 3665 +3071 111 3667 3666 3668 +3072 111 3670 3669 3671 +3073 111 3673 3672 3674 +3074 111 3676 3675 3677 +3075 111 3679 3678 3680 +3076 111 3682 3681 3683 +3077 111 3685 3684 3686 +3078 111 3688 3687 3689 +3079 111 3691 3690 3692 +3080 111 3694 3693 3695 +3081 111 3697 3696 3698 +3082 111 3700 3699 3701 +3083 111 3703 3702 3704 +3084 111 3706 3705 3707 +3085 111 3709 3708 3710 +3086 111 3712 3711 3713 +3087 111 3715 3714 3716 +3088 111 3718 3717 3719 +3089 111 3721 3720 3722 +3090 111 3724 3723 3725 +3091 111 3727 3726 3728 +3092 111 3730 3729 3731 +3093 111 3733 3732 3734 +3094 111 3736 3735 3737 +3095 111 3739 3738 3740 +3096 111 3742 3741 3743 +3097 111 3745 3744 3746 +3098 111 3748 3747 3749 +3099 111 3751 3750 3752 +3100 111 3754 3753 3755 +3101 111 3757 3756 3758 +3102 111 3760 3759 3761 +3103 111 3763 3762 3764 +3104 111 3766 3765 3767 +3105 111 3769 3768 3770 +3106 111 3772 3771 3773 +3107 111 3775 3774 3776 +3108 111 3778 3777 3779 +3109 111 3781 3780 3782 +3110 111 3784 3783 3785 +3111 111 3787 3786 3788 +3112 111 3790 3789 3791 +3113 111 3793 3792 3794 +3114 111 3796 3795 3797 +3115 111 3799 3798 3800 +3116 111 3802 3801 3803 +3117 111 3805 3804 3806 +3118 111 3808 3807 3809 +3119 111 3811 3810 3812 +3120 111 3814 3813 3815 +3121 111 3817 3816 3818 +3122 111 3820 3819 3821 +3123 111 3823 3822 3824 +3124 111 3826 3825 3827 +3125 111 3829 3828 3830 +3126 111 3832 3831 3833 +3127 111 3835 3834 3836 +3128 111 3838 3837 3839 +3129 111 3841 3840 3842 +3130 111 3844 3843 3845 +3131 111 3847 3846 3848 +3132 111 3850 3849 3851 +3133 111 3853 3852 3854 +3134 111 3856 3855 3857 +3135 111 3859 3858 3860 +3136 111 3862 3861 3863 +3137 111 3865 3864 3866 +3138 111 3868 3867 3869 +3139 111 3871 3870 3872 +3140 111 3874 3873 3875 +3141 111 3877 3876 3878 +3142 111 3880 3879 3881 +3143 111 3883 3882 3884 +3144 111 3886 3885 3887 +3145 111 3889 3888 3890 +3146 111 3892 3891 3893 +3147 111 3895 3894 3896 +3148 111 3898 3897 3899 +3149 111 3901 3900 3902 +3150 111 3904 3903 3905 +3151 111 3907 3906 3908 +3152 111 3910 3909 3911 +3153 111 3913 3912 3914 +3154 111 3916 3915 3917 +3155 111 3919 3918 3920 +3156 111 3922 3921 3923 +3157 111 3925 3924 3926 +3158 111 3928 3927 3929 +3159 111 3931 3930 3932 +3160 111 3934 3933 3935 +3161 111 3937 3936 3938 +3162 111 3940 3939 3941 +3163 111 3943 3942 3944 +3164 111 3946 3945 3947 +3165 111 3949 3948 3950 +3166 111 3952 3951 3953 +3167 111 3955 3954 3956 +3168 111 3958 3957 3959 +3169 111 3961 3960 3962 +3170 111 3964 3963 3965 +3171 111 3967 3966 3968 +3172 111 3970 3969 3971 +3173 111 3973 3972 3974 +3174 111 3976 3975 3977 +3175 111 3979 3978 3980 +3176 111 3982 3981 3983 +3177 111 3985 3984 3986 +3178 111 3988 3987 3989 +3179 111 3991 3990 3992 +3180 111 3994 3993 3995 +3181 111 3997 3996 3998 +3182 111 4000 3999 4001 +3183 111 4003 4002 4004 +3184 111 4006 4005 4007 +3185 111 4009 4008 4010 +3186 111 4012 4011 4013 +3187 111 4015 4014 4016 +3188 111 4018 4017 4019 +3189 111 4021 4020 4022 +3190 111 4024 4023 4025 +3191 111 4027 4026 4028 +3192 111 4030 4029 4031 +3193 111 4033 4032 4034 +3194 111 4036 4035 4037 +3195 111 4039 4038 4040 +3196 111 4042 4041 4043 +3197 111 4045 4044 4046 +3198 111 4048 4047 4049 +3199 111 4051 4050 4052 +3200 111 4054 4053 4055 +3201 111 4057 4056 4058 +3202 111 4060 4059 4061 +3203 111 4063 4062 4064 +3204 111 4066 4065 4067 +3205 111 4069 4068 4070 +3206 111 4072 4071 4073 +3207 111 4075 4074 4076 +3208 111 4078 4077 4079 +3209 111 4081 4080 4082 +3210 111 4084 4083 4085 +3211 111 4087 4086 4088 +3212 111 4090 4089 4091 +3213 111 4093 4092 4094 +3214 111 4096 4095 4097 +3215 111 4099 4098 4100 +3216 111 4102 4101 4103 +3217 111 4105 4104 4106 +3218 111 4108 4107 4109 +3219 111 4111 4110 4112 +3220 111 4114 4113 4115 +3221 111 4117 4116 4118 +3222 111 4120 4119 4121 +3223 111 4123 4122 4124 +3224 111 4126 4125 4127 +3225 111 4129 4128 4130 +3226 111 4132 4131 4133 +3227 111 4135 4134 4136 +3228 111 4138 4137 4139 +3229 111 4141 4140 4142 +3230 111 4144 4143 4145 +3231 111 4147 4146 4148 +3232 111 4150 4149 4151 +3233 111 4153 4152 4154 +3234 111 4156 4155 4157 +3235 111 4159 4158 4160 +3236 111 4162 4161 4163 +3237 111 4165 4164 4166 +3238 111 4168 4167 4169 +3239 111 4171 4170 4172 +3240 111 4174 4173 4175 +3241 111 4177 4176 4178 +3242 111 4180 4179 4181 +3243 111 4183 4182 4184 +3244 111 4186 4185 4187 +3245 111 4189 4188 4190 +3246 111 4192 4191 4193 +3247 111 4195 4194 4196 +3248 111 4198 4197 4199 +3249 111 4201 4200 4202 +3250 111 4204 4203 4205 +3251 111 4207 4206 4208 +3252 111 4210 4209 4211 +3253 111 4213 4212 4214 +3254 111 4216 4215 4217 +3255 111 4219 4218 4220 +3256 111 4222 4221 4223 +3257 111 4225 4224 4226 +3258 111 4228 4227 4229 +3259 111 4231 4230 4232 +3260 111 4234 4233 4235 +3261 111 4237 4236 4238 +3262 111 4240 4239 4241 +3263 111 4243 4242 4244 +3264 111 4246 4245 4247 +3265 111 4249 4248 4250 +3266 111 4252 4251 4253 +3267 111 4255 4254 4256 +3268 111 4258 4257 4259 +3269 111 4261 4260 4262 +3270 111 4264 4263 4265 +3271 111 4267 4266 4268 +3272 111 4270 4269 4271 +3273 111 4273 4272 4274 +3274 111 4276 4275 4277 +3275 111 4279 4278 4280 +3276 111 4282 4281 4283 +3277 111 4285 4284 4286 +3278 111 4288 4287 4289 +3279 111 4291 4290 4292 +3280 111 4294 4293 4295 +3281 111 4297 4296 4298 +3282 111 4300 4299 4301 +3283 111 4303 4302 4304 +3284 111 4306 4305 4307 +3285 111 4309 4308 4310 +3286 111 4312 4311 4313 +3287 111 4315 4314 4316 +3288 111 4318 4317 4319 +3289 111 4321 4320 4322 +3290 111 4324 4323 4325 +3291 111 4327 4326 4328 +3292 111 4330 4329 4331 +3293 111 4333 4332 4334 +3294 111 4336 4335 4337 +3295 111 4339 4338 4340 +3296 111 4342 4341 4343 +3297 111 4345 4344 4346 +3298 111 4348 4347 4349 +3299 111 4351 4350 4352 +3300 111 4354 4353 4355 +3301 111 4357 4356 4358 +3302 111 4360 4359 4361 +3303 111 4363 4362 4364 +3304 111 4366 4365 4367 +3305 111 4369 4368 4370 +3306 111 4372 4371 4373 +3307 111 4375 4374 4376 +3308 111 4378 4377 4379 +3309 111 4381 4380 4382 +3310 111 4384 4383 4385 +3311 111 4387 4386 4388 +3312 111 4390 4389 4391 +3313 111 4393 4392 4394 +3314 111 4396 4395 4397 +3315 111 4399 4398 4400 +3316 111 4402 4401 4403 +3317 111 4405 4404 4406 +3318 111 4408 4407 4409 +3319 111 4411 4410 4412 +3320 111 4414 4413 4415 +3321 111 4417 4416 4418 +3322 111 4420 4419 4421 +3323 111 4423 4422 4424 +3324 111 4426 4425 4427 +3325 111 4429 4428 4430 +3326 111 4432 4431 4433 +3327 111 4435 4434 4436 +3328 111 4438 4437 4439 +3329 111 4441 4440 4442 +3330 111 4444 4443 4445 +3331 111 4447 4446 4448 +3332 111 4450 4449 4451 +3333 111 4453 4452 4454 +3334 111 4456 4455 4457 +3335 111 4459 4458 4460 +3336 111 4462 4461 4463 +3337 111 4465 4464 4466 +3338 111 4468 4467 4469 +3339 111 4471 4470 4472 +3340 111 4474 4473 4475 +3341 111 4477 4476 4478 +3342 111 4480 4479 4481 +3343 111 4483 4482 4484 +3344 111 4486 4485 4487 +3345 111 4489 4488 4490 +3346 111 4492 4491 4493 +3347 111 4495 4494 4496 +3348 111 4498 4497 4499 +3349 111 4501 4500 4502 +3350 111 4504 4503 4505 +3351 111 4507 4506 4508 +3352 111 4510 4509 4511 +3353 111 4513 4512 4514 +3354 111 4516 4515 4517 +3355 111 4519 4518 4520 +3356 111 4522 4521 4523 +3357 111 4525 4524 4526 +3358 111 4528 4527 4529 +3359 111 4531 4530 4532 +3360 111 4534 4533 4535 +3361 111 4537 4536 4538 +3362 111 4540 4539 4541 +3363 111 4543 4542 4544 +3364 111 4546 4545 4547 +3365 111 4549 4548 4550 +3366 111 4552 4551 4553 +3367 111 4555 4554 4556 +3368 111 4558 4557 4559 +3369 111 4561 4560 4562 +3370 111 4564 4563 4565 +3371 111 4567 4566 4568 +3372 111 4570 4569 4571 +3373 111 4573 4572 4574 +3374 111 4576 4575 4577 +3375 111 4579 4578 4580 +3376 111 4582 4581 4583 +3377 111 4585 4584 4586 +3378 111 4588 4587 4589 +3379 111 4591 4590 4592 +3380 111 4594 4593 4595 +3381 111 4597 4596 4598 +3382 111 4600 4599 4601 +3383 111 4603 4602 4604 +3384 111 4606 4605 4607 +3385 111 4609 4608 4610 +3386 111 4612 4611 4613 +3387 111 4615 4614 4616 +3388 111 4618 4617 4619 +3389 111 4621 4620 4622 +3390 111 4624 4623 4625 +3391 111 4627 4626 4628 +3392 111 4630 4629 4631 +3393 111 4633 4632 4634 +3394 111 4636 4635 4637 +3395 111 4639 4638 4640 +3396 111 4642 4641 4643 +3397 111 4645 4644 4646 +3398 111 4648 4647 4649 +3399 111 4651 4650 4652 +3400 111 4654 4653 4655 +3401 111 4657 4656 4658 +3402 111 4660 4659 4661 +3403 111 4663 4662 4664 +3404 111 4666 4665 4667 +3405 111 4669 4668 4670 +3406 111 4672 4671 4673 +3407 111 4675 4674 4676 +3408 111 4678 4677 4679 +3409 111 4681 4680 4682 +3410 111 4684 4683 4685 +3411 111 4687 4686 4688 +3412 111 4690 4689 4691 +3413 111 4693 4692 4694 +3414 111 4696 4695 4697 +3415 111 4699 4698 4700 +3416 111 4702 4701 4703 +3417 111 4705 4704 4706 +3418 111 4708 4707 4709 +3419 111 4711 4710 4712 +3420 111 4714 4713 4715 +3421 111 4717 4716 4718 +3422 111 4720 4719 4721 +3423 111 4723 4722 4724 +3424 111 4726 4725 4727 +3425 111 4729 4728 4730 +3426 111 4732 4731 4733 +3427 111 4735 4734 4736 +3428 111 4738 4737 4739 +3429 111 4741 4740 4742 +3430 111 4744 4743 4745 +3431 111 4747 4746 4748 +3432 111 4750 4749 4751 +3433 111 4753 4752 4754 +3434 111 4756 4755 4757 +3435 111 4759 4758 4760 +3436 111 4762 4761 4763 +3437 111 4765 4764 4766 +3438 111 4768 4767 4769 +3439 111 4771 4770 4772 +3440 111 4774 4773 4775 +3441 111 4777 4776 4778 +3442 111 4780 4779 4781 +3443 111 4783 4782 4784 +3444 111 4786 4785 4787 +3445 111 4789 4788 4790 +3446 111 4792 4791 4793 +3447 111 4795 4794 4796 +3448 111 4798 4797 4799 +3449 111 4801 4800 4802 +3450 111 4804 4803 4805 +3451 111 4807 4806 4808 +3452 111 4810 4809 4811 +3453 111 4813 4812 4814 +3454 111 4816 4815 4817 +3455 111 4819 4818 4820 +3456 111 4822 4821 4823 +3457 111 4825 4824 4826 +3458 111 4828 4827 4829 +3459 111 4831 4830 4832 +3460 111 4834 4833 4835 +3461 111 4837 4836 4838 +3462 111 4840 4839 4841 +3463 111 4843 4842 4844 +3464 111 4846 4845 4847 +3465 111 4849 4848 4850 +3466 111 4852 4851 4853 +3467 111 4855 4854 4856 +3468 111 4858 4857 4859 +3469 111 4861 4860 4862 +3470 111 4864 4863 4865 +3471 111 4867 4866 4868 +3472 111 4870 4869 4871 +3473 111 4873 4872 4874 +3474 111 4876 4875 4877 +3475 111 4879 4878 4880 +3476 111 4882 4881 4883 +3477 111 4885 4884 4886 +3478 111 4888 4887 4889 +3479 111 4891 4890 4892 +3480 111 4894 4893 4895 +3481 111 4897 4896 4898 +3482 111 4900 4899 4901 +3483 111 4903 4902 4904 +3484 111 4906 4905 4907 +3485 111 4909 4908 4910 +3486 111 4912 4911 4913 +3487 111 4915 4914 4916 +3488 111 4918 4917 4919 +3489 111 4921 4920 4922 +3490 111 4924 4923 4925 +3491 111 4927 4926 4928 +3492 111 4930 4929 4931 +3493 111 4933 4932 4934 +3494 111 4936 4935 4937 +3495 111 4939 4938 4940 +3496 111 4942 4941 4943 +3497 111 4945 4944 4946 +3498 111 4948 4947 4949 +3499 111 4951 4950 4952 +3500 111 4954 4953 4955 +3501 111 4957 4956 4958 +3502 111 4960 4959 4961 +3503 111 4963 4962 4964 +3504 111 4966 4965 4967 +3505 111 4969 4968 4970 +3506 111 4972 4971 4973 +3507 111 4975 4974 4976 +3508 111 4978 4977 4979 +3509 111 4981 4980 4982 +3510 111 4984 4983 4985 +3511 111 4987 4986 4988 +3512 111 4990 4989 4991 +3513 111 4993 4992 4994 +3514 111 4996 4995 4997 +3515 111 4999 4998 5000 +3516 111 5002 5001 5003 +3517 111 5005 5004 5006 +3518 111 5008 5007 5009 +3519 111 5011 5010 5012 +3520 111 5014 5013 5015 +3521 111 5017 5016 5018 +3522 111 5020 5019 5021 +3523 111 5023 5022 5024 +3524 111 5026 5025 5027 +3525 111 5029 5028 5030 +3526 111 5032 5031 5033 +3527 111 5035 5034 5036 +3528 111 5038 5037 5039 +3529 111 5041 5040 5042 +3530 111 5044 5043 5045 +3531 111 5047 5046 5048 +3532 111 5050 5049 5051 +3533 111 5053 5052 5054 +3534 111 5056 5055 5057 +3535 111 5059 5058 5060 +3536 111 5062 5061 5063 +3537 111 5065 5064 5066 +3538 111 5068 5067 5069 +3539 111 5071 5070 5072 +3540 111 5074 5073 5075 +3541 111 5077 5076 5078 +3542 111 5080 5079 5081 +3543 111 5083 5082 5084 +3544 111 5086 5085 5087 +3545 111 5089 5088 5090 +3546 111 5092 5091 5093 +3547 111 5095 5094 5096 +3548 111 5098 5097 5099 +3549 111 5101 5100 5102 +3550 111 5104 5103 5105 +3551 111 5107 5106 5108 +3552 111 5110 5109 5111 +3553 111 5113 5112 5114 +3554 111 5116 5115 5117 +3555 111 5119 5118 5120 +3556 111 5122 5121 5123 +3557 111 5125 5124 5126 +3558 111 5128 5127 5129 +3559 111 5131 5130 5132 +3560 111 5134 5133 5135 +3561 111 5137 5136 5138 +3562 111 5140 5139 5141 +3563 111 5143 5142 5144 +3564 111 5146 5145 5147 +3565 111 5149 5148 5150 +3566 111 5152 5151 5153 +3567 111 5155 5154 5156 +3568 111 5158 5157 5159 +3569 111 5161 5160 5162 +3570 111 5164 5163 5165 +3571 111 5167 5166 5168 +3572 111 5170 5169 5171 +3573 111 5173 5172 5174 +3574 111 5176 5175 5177 +3575 111 5179 5178 5180 +3576 111 5182 5181 5183 +3577 111 5185 5184 5186 +3578 111 5188 5187 5189 +3579 111 5191 5190 5192 +3580 111 5194 5193 5195 +3581 111 5197 5196 5198 +3582 111 5200 5199 5201 +3583 111 5203 5202 5204 +3584 111 5206 5205 5207 +3585 111 5209 5208 5210 +3586 111 5212 5211 5213 +3587 111 5215 5214 5216 +3588 111 5218 5217 5219 +3589 111 5221 5220 5222 +3590 111 5224 5223 5225 +3591 111 5227 5226 5228 +3592 111 5230 5229 5231 +3593 111 5233 5232 5234 +3594 111 5236 5235 5237 +3595 111 5239 5238 5240 +3596 111 5242 5241 5243 +3597 111 5245 5244 5246 +3598 111 5248 5247 5249 +3599 111 5251 5250 5252 +3600 111 5254 5253 5255 +3601 111 5257 5256 5258 +3602 111 5260 5259 5261 +3603 111 5263 5262 5264 +3604 111 5266 5265 5267 +3605 111 5269 5268 5270 +3606 111 5272 5271 5273 +3607 111 5275 5274 5276 +3608 111 5278 5277 5279 +3609 111 5281 5280 5282 +3610 111 5284 5283 5285 +3611 111 5287 5286 5288 +3612 111 5290 5289 5291 +3613 111 5293 5292 5294 +3614 111 5296 5295 5297 +3615 111 5299 5298 5300 +3616 111 5302 5301 5303 +3617 111 5305 5304 5306 +3618 111 5308 5307 5309 +3619 111 5311 5310 5312 +3620 111 5314 5313 5315 +3621 111 5317 5316 5318 +3622 111 5320 5319 5321 +3623 111 5323 5322 5324 +3624 111 5326 5325 5327 +3625 111 5329 5328 5330 +3626 111 5332 5331 5333 +3627 111 5335 5334 5336 +3628 111 5338 5337 5339 +3629 111 5341 5340 5342 +3630 111 5344 5343 5345 +3631 111 5347 5346 5348 +3632 111 5350 5349 5351 +3633 111 5353 5352 5354 +3634 111 5356 5355 5357 +3635 111 5359 5358 5360 +3636 111 5362 5361 5363 +3637 111 5365 5364 5366 +3638 111 5368 5367 5369 +3639 111 5371 5370 5372 +3640 111 5374 5373 5375 +3641 111 5377 5376 5378 +3642 111 5380 5379 5381 +3643 111 5383 5382 5384 +3644 111 5386 5385 5387 +3645 111 5389 5388 5390 +3646 111 5392 5391 5393 +3647 111 5395 5394 5396 +3648 111 5398 5397 5399 +3649 111 5401 5400 5402 +3650 111 5404 5403 5405 +3651 111 5407 5406 5408 +3652 111 5410 5409 5411 +3653 111 5413 5412 5414 +3654 111 5416 5415 5417 +3655 111 5419 5418 5420 +3656 111 5422 5421 5423 +3657 111 5425 5424 5426 +3658 111 5428 5427 5429 +3659 111 5431 5430 5432 +3660 111 5434 5433 5435 +3661 111 5437 5436 5438 +3662 111 5440 5439 5441 +3663 111 5443 5442 5444 +3664 111 5446 5445 5447 +3665 111 5449 5448 5450 +3666 111 5452 5451 5453 +3667 111 5455 5454 5456 +3668 111 5458 5457 5459 +3669 111 5461 5460 5462 +3670 111 5464 5463 5465 +3671 111 5467 5466 5468 +3672 111 5470 5469 5471 +3673 111 5473 5472 5474 +3674 111 5476 5475 5477 +3675 111 5479 5478 5480 +3676 111 5482 5481 5483 +3677 111 5485 5484 5486 +3678 111 5488 5487 5489 +3679 111 5491 5490 5492 +3680 111 5494 5493 5495 +3681 111 5497 5496 5498 +3682 111 5500 5499 5501 +3683 111 5503 5502 5504 +3684 111 5506 5505 5507 +3685 111 5509 5508 5510 +3686 111 5512 5511 5513 +3687 111 5515 5514 5516 +3688 111 5518 5517 5519 +3689 111 5521 5520 5522 +3690 111 5524 5523 5525 +3691 111 5527 5526 5528 +3692 111 5530 5529 5531 +3693 111 5533 5532 5534 +3694 111 5536 5535 5537 +3695 111 5539 5538 5540 +3696 111 5542 5541 5543 +3697 111 5545 5544 5546 +3698 111 5548 5547 5549 +3699 111 5551 5550 5552 +3700 111 5554 5553 5555 +3701 111 5557 5556 5558 +3702 111 5560 5559 5561 +3703 111 5563 5562 5564 +3704 111 5566 5565 5567 +3705 111 5569 5568 5570 +3706 111 5572 5571 5573 +3707 111 5575 5574 5576 +3708 111 5578 5577 5579 +3709 111 5581 5580 5582 +3710 111 5584 5583 5585 +3711 111 5587 5586 5588 +3712 111 5590 5589 5591 +3713 111 5593 5592 5594 +3714 111 5596 5595 5597 +3715 111 5599 5598 5600 +3716 111 5602 5601 5603 +3717 111 5605 5604 5606 +3718 111 5608 5607 5609 +3719 111 5611 5610 5612 +3720 111 5614 5613 5615 +3721 111 5617 5616 5618 +3722 111 5620 5619 5621 +3723 111 5623 5622 5624 +3724 111 5626 5625 5627 +3725 111 5629 5628 5630 +3726 111 5632 5631 5633 +3727 111 5635 5634 5636 +3728 111 5638 5637 5639 +3729 111 5641 5640 5642 +3730 111 5644 5643 5645 +3731 111 5647 5646 5648 +3732 111 5650 5649 5651 +3733 111 5653 5652 5654 +3734 111 5656 5655 5657 +3735 111 5659 5658 5660 +3736 111 5662 5661 5663 +3737 111 5665 5664 5666 +3738 111 5668 5667 5669 +3739 111 5671 5670 5672 +3740 111 5674 5673 5675 +3741 111 5677 5676 5678 +3742 111 5680 5679 5681 +3743 111 5683 5682 5684 +3744 111 5686 5685 5687 +3745 111 5689 5688 5690 +3746 111 5692 5691 5693 +3747 111 5695 5694 5696 +3748 111 5698 5697 5699 +3749 111 5701 5700 5702 +3750 111 5704 5703 5705 +3751 111 5707 5706 5708 +3752 111 5710 5709 5711 +3753 111 5713 5712 5714 +3754 111 5716 5715 5717 +3755 111 5719 5718 5720 +3756 111 5722 5721 5723 +3757 111 5725 5724 5726 +3758 111 5728 5727 5729 +3759 111 5731 5730 5732 +3760 111 5734 5733 5735 +3761 111 5737 5736 5738 +3762 111 5740 5739 5741 +3763 111 5743 5742 5744 +3764 111 5746 5745 5747 +3765 111 5749 5748 5750 +3766 111 5752 5751 5753 +3767 111 5755 5754 5756 +3768 111 5758 5757 5759 +3769 111 5761 5760 5762 +3770 111 5764 5763 5765 +3771 111 5767 5766 5768 +3772 111 5770 5769 5771 +3773 111 5773 5772 5774 +3774 111 5776 5775 5777 +3775 111 5779 5778 5780 +3776 111 5782 5781 5783 +3777 111 5785 5784 5786 +3778 111 5788 5787 5789 +3779 111 5791 5790 5792 +3780 111 5794 5793 5795 +3781 111 5797 5796 5798 +3782 111 5800 5799 5801 +3783 111 5803 5802 5804 +3784 111 5806 5805 5807 +3785 111 5809 5808 5810 +3786 111 5812 5811 5813 +3787 111 5815 5814 5816 +3788 111 5818 5817 5819 +3789 111 5821 5820 5822 +3790 111 5824 5823 5825 +3791 111 5827 5826 5828 +3792 111 5830 5829 5831 +3793 111 5833 5832 5834 +3794 111 5836 5835 5837 +3795 111 5839 5838 5840 +3796 111 5842 5841 5843 +3797 111 5845 5844 5846 +3798 111 5848 5847 5849 +3799 111 5851 5850 5852 +3800 111 5854 5853 5855 +3801 111 5857 5856 5858 +3802 111 5860 5859 5861 +3803 111 5863 5862 5864 +3804 111 5866 5865 5867 +3805 111 5869 5868 5870 +3806 111 5872 5871 5873 +3807 111 5875 5874 5876 +3808 111 5878 5877 5879 +3809 111 5881 5880 5882 +3810 111 5884 5883 5885 +3811 111 5887 5886 5888 +3812 111 5890 5889 5891 +3813 111 5893 5892 5894 +3814 111 5896 5895 5897 +3815 111 5899 5898 5900 +3816 111 5902 5901 5903 +3817 111 5905 5904 5906 +3818 111 5908 5907 5909 +3819 111 5911 5910 5912 +3820 111 5914 5913 5915 +3821 111 5917 5916 5918 +3822 111 5920 5919 5921 +3823 111 5923 5922 5924 +3824 111 5926 5925 5927 +3825 111 5929 5928 5930 +3826 111 5932 5931 5933 +3827 111 5935 5934 5936 +3828 111 5938 5937 5939 +3829 111 5941 5940 5942 +3830 111 5944 5943 5945 +3831 111 5947 5946 5948 +3832 111 5950 5949 5951 +3833 111 5953 5952 5954 +3834 111 5956 5955 5957 +3835 111 5959 5958 5960 +3836 111 5962 5961 5963 +3837 111 5965 5964 5966 +3838 111 5968 5967 5969 +3839 111 5971 5970 5972 +3840 111 5974 5973 5975 +3841 111 5977 5976 5978 +3842 111 5980 5979 5981 +3843 111 5983 5982 5984 +3844 111 5986 5985 5987 +3845 111 5989 5988 5990 +3846 111 5992 5991 5993 +3847 111 5995 5994 5996 +3848 111 5998 5997 5999 +3849 111 6001 6000 6002 +3850 111 6004 6003 6005 +3851 111 6007 6006 6008 +3852 111 6010 6009 6011 +3853 111 6013 6012 6014 +3854 111 6016 6015 6017 +3855 111 6019 6018 6020 +3856 111 6022 6021 6023 +3857 111 6025 6024 6026 +3858 111 6028 6027 6029 +3859 111 6031 6030 6032 +3860 111 6034 6033 6035 +3861 111 6037 6036 6038 +3862 111 6040 6039 6041 +3863 111 6043 6042 6044 +3864 111 6046 6045 6047 +3865 111 6049 6048 6050 +3866 111 6052 6051 6053 +3867 111 6055 6054 6056 +3868 111 6058 6057 6059 +3869 111 6061 6060 6062 +3870 111 6064 6063 6065 +3871 111 6067 6066 6068 +3872 111 6070 6069 6071 +3873 111 6073 6072 6074 +3874 111 6076 6075 6077 +3875 111 6079 6078 6080 +3876 111 6082 6081 6083 +3877 111 6085 6084 6086 +3878 111 6088 6087 6089 +3879 111 6091 6090 6092 +3880 111 6094 6093 6095 +3881 111 6097 6096 6098 +3882 111 6100 6099 6101 +3883 111 6103 6102 6104 +3884 111 6106 6105 6107 +3885 111 6109 6108 6110 +3886 111 6112 6111 6113 +3887 111 6115 6114 6116 +3888 111 6118 6117 6119 +3889 111 6121 6120 6122 +3890 111 6124 6123 6125 +3891 111 6127 6126 6128 +3892 111 6130 6129 6131 +3893 111 6133 6132 6134 +3894 111 6136 6135 6137 +3895 111 6139 6138 6140 +3896 111 6142 6141 6143 +3897 111 6145 6144 6146 +3898 111 6148 6147 6149 +3899 111 6151 6150 6152 +3900 111 6154 6153 6155 +3901 111 6157 6156 6158 +3902 111 6160 6159 6161 +3903 111 6163 6162 6164 +3904 111 6166 6165 6167 +3905 111 6169 6168 6170 +3906 111 6172 6171 6173 +3907 111 6175 6174 6176 +3908 111 6178 6177 6179 +3909 111 6181 6180 6182 +3910 111 6184 6183 6185 +3911 111 6187 6186 6188 +3912 111 6190 6189 6191 +3913 111 6193 6192 6194 +3914 111 6196 6195 6197 +3915 111 6199 6198 6200 +3916 111 6202 6201 6203 +3917 111 6205 6204 6206 +3918 111 6208 6207 6209 +3919 111 6211 6210 6212 +3920 111 6214 6213 6215 +3921 111 6217 6216 6218 +3922 111 6220 6219 6221 +3923 111 6223 6222 6224 +3924 111 6226 6225 6227 +3925 111 6229 6228 6230 +3926 111 6232 6231 6233 +3927 111 6235 6234 6236 +3928 111 6238 6237 6239 +3929 111 6241 6240 6242 +3930 111 6244 6243 6245 +3931 111 6247 6246 6248 +3932 111 6250 6249 6251 +3933 111 6253 6252 6254 +3934 111 6256 6255 6257 +3935 111 6259 6258 6260 +3936 111 6262 6261 6263 +3937 111 6265 6264 6266 +3938 111 6268 6267 6269 +3939 111 6271 6270 6272 +3940 111 6274 6273 6275 +3941 111 6277 6276 6278 +3942 111 6280 6279 6281 +3943 111 6283 6282 6284 +3944 111 6286 6285 6287 +3945 111 6289 6288 6290 +3946 111 6292 6291 6293 +3947 111 6295 6294 6296 +3948 111 6298 6297 6299 +3949 111 6301 6300 6302 +3950 111 6304 6303 6305 +3951 111 6307 6306 6308 +3952 111 6310 6309 6311 +3953 111 6313 6312 6314 +3954 111 6316 6315 6317 +3955 111 6319 6318 6320 +3956 111 6322 6321 6323 +3957 111 6325 6324 6326 +3958 111 6328 6327 6329 +3959 111 6331 6330 6332 +3960 111 6334 6333 6335 +3961 111 6337 6336 6338 +3962 111 6340 6339 6341 +3963 111 6343 6342 6344 +3964 111 6346 6345 6347 +3965 111 6349 6348 6350 +3966 111 6352 6351 6353 +3967 111 6355 6354 6356 +3968 111 6358 6357 6359 +3969 111 6361 6360 6362 +3970 111 6364 6363 6365 +3971 111 6367 6366 6368 +3972 111 6370 6369 6371 +3973 111 6373 6372 6374 +3974 111 6376 6375 6377 +3975 111 6379 6378 6380 +3976 111 6382 6381 6383 +3977 111 6385 6384 6386 +3978 111 6388 6387 6389 +3979 111 6391 6390 6392 +3980 111 6394 6393 6395 +3981 111 6397 6396 6398 +3982 111 6400 6399 6401 +3983 111 6403 6402 6404 +3984 111 6406 6405 6407 +3985 111 6409 6408 6410 +3986 111 6412 6411 6413 +3987 111 6415 6414 6416 +3988 111 6418 6417 6419 +3989 111 6421 6420 6422 +3990 111 6424 6423 6425 +3991 111 6427 6426 6428 +3992 111 6430 6429 6431 +3993 111 6433 6432 6434 +3994 111 6436 6435 6437 +3995 111 6439 6438 6440 +3996 111 6442 6441 6443 +3997 111 6445 6444 6446 +3998 111 6448 6447 6449 +3999 111 6451 6450 6452 +4000 111 6454 6453 6455 +4001 111 6457 6456 6458 +4002 111 6460 6459 6461 +4003 111 6463 6462 6464 +4004 111 6466 6465 6467 +4005 111 6469 6468 6470 +4006 111 6472 6471 6473 +4007 111 6475 6474 6476 +4008 111 6478 6477 6479 +4009 111 6481 6480 6482 +4010 111 6484 6483 6485 +4011 111 6487 6486 6488 +4012 111 6490 6489 6491 +4013 111 6493 6492 6494 +4014 111 6496 6495 6497 +4015 111 6499 6498 6500 +4016 111 6502 6501 6503 +4017 111 6505 6504 6506 +4018 111 6508 6507 6509 +4019 111 6511 6510 6512 +4020 111 6514 6513 6515 +4021 111 6517 6516 6518 +4022 111 6520 6519 6521 +4023 111 6523 6522 6524 +4024 111 6526 6525 6527 +4025 111 6529 6528 6530 +4026 111 6532 6531 6533 +4027 111 6535 6534 6536 +4028 111 6538 6537 6539 +4029 111 6541 6540 6542 +4030 111 6544 6543 6545 +4031 111 6547 6546 6548 +4032 111 6550 6549 6551 +4033 111 6553 6552 6554 +4034 111 6556 6555 6557 +4035 111 6559 6558 6560 +4036 111 6562 6561 6563 +4037 111 6565 6564 6566 +4038 111 6568 6567 6569 +4039 111 6571 6570 6572 +4040 111 6574 6573 6575 +4041 111 6577 6576 6578 +4042 111 6580 6579 6581 +4043 111 6583 6582 6584 +4044 111 6586 6585 6587 +4045 111 6589 6588 6590 +4046 111 6592 6591 6593 +4047 111 6595 6594 6596 +4048 111 6598 6597 6599 +4049 111 6601 6600 6602 +4050 111 6604 6603 6605 +4051 111 6607 6606 6608 +4052 111 6610 6609 6611 +4053 111 6613 6612 6614 +4054 111 6616 6615 6617 +4055 111 6619 6618 6620 +4056 111 6622 6621 6623 +4057 111 6625 6624 6626 +4058 111 6628 6627 6629 +4059 111 6631 6630 6632 +4060 111 6634 6633 6635 +4061 111 6637 6636 6638 +4062 111 6640 6639 6641 +4063 111 6643 6642 6644 +4064 111 6646 6645 6647 +4065 111 6649 6648 6650 +4066 111 6652 6651 6653 +4067 111 6655 6654 6656 +4068 111 6658 6657 6659 +4069 111 6661 6660 6662 +4070 111 6664 6663 6665 +4071 111 6667 6666 6668 +4072 111 6670 6669 6671 +4073 111 6673 6672 6674 +4074 111 6676 6675 6677 +4075 111 6679 6678 6680 +4076 111 6682 6681 6683 +4077 111 6685 6684 6686 +4078 111 6688 6687 6689 +4079 111 6691 6690 6692 +4080 111 6694 6693 6695 +4081 111 6697 6696 6698 +4082 111 6700 6699 6701 +4083 111 6703 6702 6704 +4084 111 6706 6705 6707 +4085 111 6709 6708 6710 +4086 111 6712 6711 6713 +4087 111 6715 6714 6716 +4088 111 6718 6717 6719 +4089 111 6721 6720 6722 +4090 111 6724 6723 6725 +4091 111 6727 6726 6728 +4092 111 6730 6729 6731 +4093 111 6733 6732 6734 +4094 111 6736 6735 6737 +4095 111 6739 6738 6740 +4096 111 6742 6741 6743 +4097 111 6745 6744 6746 +4098 111 6748 6747 6749 +4099 111 6751 6750 6752 +4100 111 6754 6753 6755 +4101 111 6757 6756 6758 +4102 111 6760 6759 6761 +4103 111 6763 6762 6764 +4104 111 6766 6765 6767 +4105 111 6769 6768 6770 +4106 111 6772 6771 6773 +4107 111 6775 6774 6776 +4108 111 6778 6777 6779 +4109 111 6781 6780 6782 +4110 111 6784 6783 6785 +4111 111 6787 6786 6788 +4112 111 6790 6789 6791 +4113 111 6793 6792 6794 +4114 111 6796 6795 6797 +4115 111 6799 6798 6800 +4116 111 6802 6801 6803 +4117 111 6805 6804 6806 +4118 111 6808 6807 6809 +4119 111 6811 6810 6812 +4120 111 6814 6813 6815 +4121 111 6817 6816 6818 +4122 111 6820 6819 6821 +4123 111 6823 6822 6824 +4124 111 6826 6825 6827 +4125 111 6829 6828 6830 +4126 111 6832 6831 6833 +4127 111 6835 6834 6836 +4128 111 6838 6837 6839 +4129 111 6841 6840 6842 +4130 111 6844 6843 6845 +4131 111 6847 6846 6848 +4132 111 6850 6849 6851 +4133 111 6853 6852 6854 +4134 111 6856 6855 6857 +4135 111 6859 6858 6860 +4136 111 6862 6861 6863 +4137 111 6865 6864 6866 +4138 111 6868 6867 6869 +4139 111 6871 6870 6872 +4140 111 6874 6873 6875 +4141 111 6877 6876 6878 +4142 111 6880 6879 6881 +4143 111 6883 6882 6884 +4144 111 6886 6885 6887 +4145 111 6889 6888 6890 +4146 111 6892 6891 6893 +4147 111 6895 6894 6896 +4148 111 6898 6897 6899 +4149 111 6901 6900 6902 +4150 111 6904 6903 6905 +4151 111 6907 6906 6908 +4152 111 6910 6909 6911 +4153 111 6913 6912 6914 +4154 111 6916 6915 6917 +4155 111 6919 6918 6920 +4156 111 6922 6921 6923 +4157 111 6925 6924 6926 +4158 111 6928 6927 6929 +4159 111 6931 6930 6932 +4160 111 6934 6933 6935 +4161 111 6937 6936 6938 +4162 111 6940 6939 6941 +4163 111 6943 6942 6944 +4164 111 6946 6945 6947 +4165 111 6949 6948 6950 +4166 111 6952 6951 6953 +4167 111 6955 6954 6956 +4168 111 6958 6957 6959 +4169 111 6961 6960 6962 +4170 111 6964 6963 6965 +4171 111 6967 6966 6968 +4172 111 6970 6969 6971 +4173 111 6973 6972 6974 +4174 111 6976 6975 6977 +4175 111 6979 6978 6980 +4176 111 6982 6981 6983 +4177 111 6985 6984 6986 +4178 111 6988 6987 6989 +4179 111 6991 6990 6992 +4180 111 6994 6993 6995 +4181 111 6997 6996 6998 +4182 111 7000 6999 7001 +4183 111 7003 7002 7004 +4184 111 7006 7005 7007 +4185 111 7009 7008 7010 +4186 111 7012 7011 7013 +4187 111 7015 7014 7016 +4188 111 7018 7017 7019 +4189 111 7021 7020 7022 +4190 111 7024 7023 7025 +4191 111 7027 7026 7028 +4192 111 7030 7029 7031 +4193 111 7033 7032 7034 +4194 111 7036 7035 7037 +4195 111 7039 7038 7040 +4196 111 7042 7041 7043 +4197 111 7045 7044 7046 +4198 111 7048 7047 7049 +4199 111 7051 7050 7052 +4200 111 7054 7053 7055 +4201 111 7057 7056 7058 +4202 111 7060 7059 7061 +4203 111 7063 7062 7064 +4204 111 7066 7065 7067 +4205 111 7069 7068 7070 +4206 111 7072 7071 7073 +4207 111 7075 7074 7076 +4208 111 7078 7077 7079 +4209 111 7081 7080 7082 +4210 111 7084 7083 7085 +4211 111 7087 7086 7088 +4212 111 7090 7089 7091 +4213 111 7093 7092 7094 +4214 111 7096 7095 7097 +4215 111 7099 7098 7100 +4216 111 7102 7101 7103 +4217 111 7105 7104 7106 +4218 111 7108 7107 7109 +4219 111 7111 7110 7112 +4220 111 7114 7113 7115 +4221 111 7117 7116 7118 +4222 111 7120 7119 7121 +4223 111 7123 7122 7124 +4224 111 7126 7125 7127 +4225 111 7129 7128 7130 +4226 111 7132 7131 7133 +4227 111 7135 7134 7136 +4228 111 7138 7137 7139 +4229 111 7141 7140 7142 +4230 111 7144 7143 7145 +4231 111 7147 7146 7148 +4232 111 7150 7149 7151 +4233 111 7153 7152 7154 +4234 111 7156 7155 7157 +4235 111 7159 7158 7160 +4236 111 7162 7161 7163 +4237 111 7165 7164 7166 +4238 111 7168 7167 7169 +4239 111 7171 7170 7172 +4240 111 7174 7173 7175 +4241 111 7177 7176 7178 +4242 111 7180 7179 7181 +4243 111 7183 7182 7184 +4244 111 7186 7185 7187 +4245 111 7189 7188 7190 +4246 111 7192 7191 7193 +4247 111 7195 7194 7196 +4248 111 7198 7197 7199 +4249 111 7201 7200 7202 +4250 111 7204 7203 7205 +4251 111 7207 7206 7208 +4252 111 7210 7209 7211 +4253 111 7213 7212 7214 +4254 111 7216 7215 7217 +4255 111 7219 7218 7220 +4256 111 7222 7221 7223 +4257 111 7225 7224 7226 +4258 111 7228 7227 7229 +4259 111 7231 7230 7232 +4260 111 7234 7233 7235 +4261 111 7237 7236 7238 +4262 111 7240 7239 7241 +4263 111 7243 7242 7244 +4264 111 7246 7245 7247 +4265 111 7249 7248 7250 +4266 111 7252 7251 7253 +4267 111 7255 7254 7256 +4268 111 7258 7257 7259 +4269 111 7261 7260 7262 +4270 111 7264 7263 7265 +4271 111 7267 7266 7268 +4272 111 7270 7269 7271 +4273 111 7273 7272 7274 +4274 111 7276 7275 7277 +4275 111 7279 7278 7280 +4276 111 7282 7281 7283 +4277 111 7285 7284 7286 +4278 111 7288 7287 7289 +4279 111 7291 7290 7292 +4280 111 7294 7293 7295 +4281 111 7297 7296 7298 +4282 111 7300 7299 7301 +4283 111 7303 7302 7304 +4284 111 7306 7305 7307 +4285 111 7309 7308 7310 +4286 111 7312 7311 7313 +4287 111 7315 7314 7316 +4288 111 7318 7317 7319 +4289 111 7321 7320 7322 +4290 111 7324 7323 7325 +4291 111 7327 7326 7328 +4292 111 7330 7329 7331 +4293 111 7333 7332 7334 +4294 111 7336 7335 7337 +4295 111 7339 7338 7340 +4296 111 7342 7341 7343 +4297 111 7345 7344 7346 +4298 111 7348 7347 7349 +4299 111 7351 7350 7352 +4300 111 7354 7353 7355 +4301 111 7357 7356 7358 +4302 111 7360 7359 7361 +4303 111 7363 7362 7364 +4304 111 7366 7365 7367 +4305 111 7369 7368 7370 +4306 111 7372 7371 7373 +4307 111 7375 7374 7376 +4308 111 7378 7377 7379 +4309 111 7381 7380 7382 +4310 111 7384 7383 7385 +4311 111 7387 7386 7388 +4312 111 7390 7389 7391 +4313 111 7393 7392 7394 +4314 111 7396 7395 7397 +4315 111 7399 7398 7400 +4316 111 7402 7401 7403 +4317 111 7405 7404 7406 +4318 111 7408 7407 7409 +4319 111 7411 7410 7412 +4320 111 7414 7413 7415 +4321 111 7417 7416 7418 +4322 111 7420 7419 7421 +4323 111 7423 7422 7424 +4324 111 7426 7425 7427 +4325 111 7429 7428 7430 +4326 111 7432 7431 7433 +4327 111 7435 7434 7436 +4328 111 7438 7437 7439 +4329 111 7441 7440 7442 +4330 111 7444 7443 7445 +4331 111 7447 7446 7448 +4332 111 7450 7449 7451 +4333 111 7453 7452 7454 +4334 111 7456 7455 7457 +4335 111 7459 7458 7460 +4336 111 7462 7461 7463 +4337 111 7465 7464 7466 +4338 111 7468 7467 7469 +4339 111 7471 7470 7472 +4340 111 7474 7473 7475 +4341 111 7477 7476 7478 +4342 111 7480 7479 7481 +4343 111 7483 7482 7484 +4344 111 7486 7485 7487 +4345 111 7489 7488 7490 +4346 111 7492 7491 7493 +4347 111 7495 7494 7496 +4348 111 7498 7497 7499 +4349 111 7501 7500 7502 +4350 111 7504 7503 7505 +4351 111 7507 7506 7508 +4352 111 7510 7509 7511 +4353 111 7513 7512 7514 +4354 111 7516 7515 7517 +4355 111 7519 7518 7520 +4356 111 7522 7521 7523 +4357 111 7525 7524 7526 +4358 111 7528 7527 7529 +4359 111 7531 7530 7532 +4360 111 7534 7533 7535 +4361 111 7537 7536 7538 +4362 111 7540 7539 7541 +4363 111 7543 7542 7544 +4364 111 7546 7545 7547 +4365 111 7549 7548 7550 +4366 111 7552 7551 7553 +4367 111 7555 7554 7556 +4368 111 7558 7557 7559 +4369 111 7561 7560 7562 +4370 111 7564 7563 7565 +4371 111 7567 7566 7568 +4372 111 7570 7569 7571 +4373 111 7573 7572 7574 +4374 111 7576 7575 7577 +4375 111 7579 7578 7580 +4376 111 7582 7581 7583 +4377 111 7585 7584 7586 +4378 111 7588 7587 7589 +4379 111 7591 7590 7592 +4380 111 7594 7593 7595 +4381 111 7597 7596 7598 +4382 111 7600 7599 7601 +4383 111 7603 7602 7604 +4384 111 7606 7605 7607 +4385 111 7609 7608 7610 +4386 111 7612 7611 7613 +4387 111 7615 7614 7616 +4388 111 7618 7617 7619 +4389 111 7621 7620 7622 +4390 111 7624 7623 7625 +4391 111 7627 7626 7628 +4392 111 7630 7629 7631 +4393 111 7633 7632 7634 +4394 111 7636 7635 7637 +4395 111 7639 7638 7640 +4396 111 7642 7641 7643 +4397 111 7645 7644 7646 +4398 111 7648 7647 7649 +4399 111 7651 7650 7652 +4400 111 7654 7653 7655 +4401 111 7657 7656 7658 +4402 111 7660 7659 7661 +4403 111 7663 7662 7664 +4404 111 7666 7665 7667 +4405 111 7669 7668 7670 +4406 111 7672 7671 7673 +4407 111 7675 7674 7676 +4408 111 7678 7677 7679 +4409 111 7681 7680 7682 +4410 111 7684 7683 7685 +4411 111 7687 7686 7688 +4412 111 7690 7689 7691 +4413 111 7693 7692 7694 +4414 111 7696 7695 7697 +4415 111 7699 7698 7700 +4416 111 7702 7701 7703 +4417 111 7705 7704 7706 +4418 111 7708 7707 7709 +4419 111 7711 7710 7712 +4420 111 7714 7713 7715 +4421 111 7717 7716 7718 +4422 111 7720 7719 7721 +4423 111 7723 7722 7724 +4424 111 7726 7725 7727 +4425 111 7729 7728 7730 +4426 111 7732 7731 7733 +4427 111 7735 7734 7736 +4428 111 7738 7737 7739 +4429 111 7741 7740 7742 +4430 111 7744 7743 7745 +4431 111 7747 7746 7748 +4432 111 7750 7749 7751 +4433 111 7753 7752 7754 +4434 111 7756 7755 7757 +4435 111 7759 7758 7760 +4436 111 7762 7761 7763 +4437 111 7765 7764 7766 +4438 111 7768 7767 7769 +4439 111 7771 7770 7772 +4440 111 7774 7773 7775 +4441 111 7777 7776 7778 +4442 111 7780 7779 7781 +4443 111 7783 7782 7784 +4444 111 7786 7785 7787 +4445 111 7789 7788 7790 +4446 111 7792 7791 7793 +4447 111 7795 7794 7796 +4448 111 7798 7797 7799 +4449 111 7801 7800 7802 +4450 111 7804 7803 7805 +4451 111 7807 7806 7808 +4452 111 7810 7809 7811 +4453 111 7813 7812 7814 +4454 111 7816 7815 7817 +4455 111 7819 7818 7820 +4456 111 7822 7821 7823 +4457 111 7825 7824 7826 +4458 111 7828 7827 7829 +4459 111 7831 7830 7832 +4460 111 7834 7833 7835 +4461 111 7837 7836 7838 +4462 111 7840 7839 7841 +4463 111 7843 7842 7844 +4464 111 7846 7845 7847 +4465 111 7849 7848 7850 +4466 111 7852 7851 7853 +4467 111 7855 7854 7856 +4468 111 7858 7857 7859 +4469 111 7861 7860 7862 +4470 111 7864 7863 7865 +4471 111 7867 7866 7868 +4472 111 7870 7869 7871 +4473 111 7873 7872 7874 +4474 111 7876 7875 7877 +4475 111 7879 7878 7880 +4476 111 7882 7881 7883 +4477 111 7885 7884 7886 +4478 111 7888 7887 7889 +4479 111 7891 7890 7892 +4480 111 7894 7893 7895 +4481 111 7897 7896 7898 +4482 111 7900 7899 7901 +4483 111 7903 7902 7904 +4484 111 7906 7905 7907 +4485 111 7909 7908 7910 +4486 111 7912 7911 7913 +4487 111 7915 7914 7916 +4488 111 7918 7917 7919 +4489 111 7921 7920 7922 +4490 111 7924 7923 7925 +4491 111 7927 7926 7928 +4492 111 7930 7929 7931 +4493 111 7933 7932 7934 +4494 111 7936 7935 7937 +4495 111 7939 7938 7940 +4496 111 7942 7941 7943 +4497 111 7945 7944 7946 +4498 111 7948 7947 7949 +4499 111 7951 7950 7952 +4500 111 7954 7953 7955 +4501 111 7957 7956 7958 +4502 111 7960 7959 7961 +4503 111 7963 7962 7964 +4504 111 7966 7965 7967 +4505 111 7969 7968 7970 +4506 111 7972 7971 7973 +4507 111 7975 7974 7976 +4508 111 7978 7977 7979 +4509 111 7981 7980 7982 +4510 111 7984 7983 7985 +4511 111 7987 7986 7988 +4512 111 7990 7989 7991 +4513 111 7993 7992 7994 +4514 111 7996 7995 7997 +4515 111 7999 7998 8000 +4516 111 8002 8001 8003 +4517 111 8005 8004 8006 +4518 111 8008 8007 8009 +4519 111 8011 8010 8012 +4520 111 8014 8013 8015 +4521 111 8017 8016 8018 +4522 111 8020 8019 8021 +4523 111 8023 8022 8024 +4524 111 8026 8025 8027 +4525 111 8029 8028 8030 +4526 111 8032 8031 8033 +4527 111 8035 8034 8036 +4528 111 8038 8037 8039 +4529 111 8041 8040 8042 +4530 111 8044 8043 8045 +4531 111 8047 8046 8048 +4532 111 8050 8049 8051 +4533 111 8053 8052 8054 +4534 111 8056 8055 8057 +4535 111 8059 8058 8060 +4536 111 8062 8061 8063 +4537 111 8065 8064 8066 +4538 111 8068 8067 8069 +4539 111 8071 8070 8072 +4540 111 8074 8073 8075 +4541 111 8077 8076 8078 +4542 111 8080 8079 8081 +4543 111 8083 8082 8084 +4544 111 8086 8085 8087 +4545 111 8089 8088 8090 +4546 111 8092 8091 8093 +4547 111 8095 8094 8096 +4548 111 8098 8097 8099 +4549 111 8101 8100 8102 +4550 111 8104 8103 8105 +4551 111 8107 8106 8108 +4552 111 8110 8109 8111 +4553 111 8113 8112 8114 +4554 111 8116 8115 8117 +4555 111 8119 8118 8120 +4556 111 8122 8121 8123 +4557 111 8125 8124 8126 +4558 111 8128 8127 8129 +4559 111 8131 8130 8132 +4560 111 8134 8133 8135 +4561 111 8137 8136 8138 +4562 111 8140 8139 8141 +4563 111 8143 8142 8144 +4564 111 8146 8145 8147 +4565 111 8149 8148 8150 +4566 111 8152 8151 8153 +4567 111 8155 8154 8156 +4568 111 8158 8157 8159 +4569 111 8161 8160 8162 +4570 111 8164 8163 8165 +4571 111 8167 8166 8168 +4572 111 8170 8169 8171 +4573 111 8173 8172 8174 +4574 111 8176 8175 8177 +4575 111 8179 8178 8180 +4576 111 8182 8181 8183 +4577 111 8185 8184 8186 +4578 111 8188 8187 8189 +4579 111 8191 8190 8192 +4580 111 8194 8193 8195 +4581 111 8197 8196 8198 +4582 111 8200 8199 8201 +4583 111 8203 8202 8204 +4584 111 8206 8205 8207 +4585 111 8209 8208 8210 +4586 111 8212 8211 8213 +4587 111 8215 8214 8216 +4588 111 8218 8217 8219 +4589 111 8221 8220 8222 +4590 111 8224 8223 8225 +4591 111 8227 8226 8228 +4592 111 8230 8229 8231 +4593 111 8233 8232 8234 +4594 111 8236 8235 8237 +4595 111 8239 8238 8240 +4596 111 8242 8241 8243 +4597 111 8245 8244 8246 +4598 111 8248 8247 8249 +4599 111 8251 8250 8252 +4600 111 8254 8253 8255 +4601 111 8257 8256 8258 +4602 111 8260 8259 8261 +4603 111 8263 8262 8264 +4604 111 8266 8265 8267 +4605 111 8269 8268 8270 +4606 111 8272 8271 8273 +4607 111 8275 8274 8276 +4608 111 8278 8277 8279 +4609 111 8281 8280 8282 +4610 111 8284 8283 8285 +4611 111 8287 8286 8288 +4612 111 8290 8289 8291 +4613 111 8293 8292 8294 +4614 111 8296 8295 8297 +4615 111 8299 8298 8300 +4616 111 8302 8301 8303 +4617 111 8305 8304 8306 +4618 111 8308 8307 8309 +4619 111 8311 8310 8312 +4620 111 8314 8313 8315 +4621 111 8317 8316 8318 +4622 111 8320 8319 8321 +4623 111 8323 8322 8324 +4624 111 8326 8325 8327 +4625 111 8329 8328 8330 +4626 111 8332 8331 8333 +4627 111 8335 8334 8336 +4628 111 8338 8337 8339 +4629 111 8341 8340 8342 +4630 111 8344 8343 8345 +4631 111 8347 8346 8348 +4632 111 8350 8349 8351 +4633 111 8353 8352 8354 +4634 111 8356 8355 8357 +4635 111 8359 8358 8360 +4636 111 8362 8361 8363 +4637 111 8365 8364 8366 +4638 111 8368 8367 8369 +4639 111 8371 8370 8372 +4640 111 8374 8373 8375 +4641 111 8377 8376 8378 +4642 111 8380 8379 8381 +4643 111 8383 8382 8384 +4644 111 8386 8385 8387 +4645 111 8389 8388 8390 +4646 111 8392 8391 8393 +4647 111 8395 8394 8396 +4648 111 8398 8397 8399 +4649 111 8401 8400 8402 +4650 111 8404 8403 8405 +4651 111 8407 8406 8408 +4652 111 8410 8409 8411 +4653 111 8413 8412 8414 +4654 111 8416 8415 8417 +4655 111 8419 8418 8420 +4656 111 8422 8421 8423 +4657 111 8425 8424 8426 +4658 111 8428 8427 8429 +4659 111 8431 8430 8432 +4660 111 8434 8433 8435 +4661 111 8437 8436 8438 +4662 111 8440 8439 8441 +4663 111 8443 8442 8444 +4664 111 8446 8445 8447 +4665 111 8449 8448 8450 +4666 111 8452 8451 8453 +4667 111 8455 8454 8456 +4668 111 8458 8457 8459 +4669 111 8461 8460 8462 +4670 111 8464 8463 8465 +4671 111 8467 8466 8468 +4672 111 8470 8469 8471 +4673 111 8473 8472 8474 +4674 111 8476 8475 8477 +4675 111 8479 8478 8480 +4676 111 8482 8481 8483 +4677 111 8485 8484 8486 +4678 111 8488 8487 8489 +4679 111 8491 8490 8492 +4680 111 8494 8493 8495 +4681 111 8497 8496 8498 +4682 111 8500 8499 8501 +4683 111 8503 8502 8504 +4684 111 8506 8505 8507 +4685 111 8509 8508 8510 +4686 111 8512 8511 8513 +4687 111 8515 8514 8516 +4688 111 8518 8517 8519 +4689 111 8521 8520 8522 +4690 111 8524 8523 8525 +4691 111 8527 8526 8528 +4692 111 8530 8529 8531 +4693 111 8533 8532 8534 +4694 111 8536 8535 8537 +4695 111 8539 8538 8540 +4696 111 8542 8541 8543 +4697 111 8545 8544 8546 +4698 111 8548 8547 8549 +4699 111 8551 8550 8552 +4700 111 8554 8553 8555 +4701 111 8557 8556 8558 +4702 111 8560 8559 8561 +4703 111 8563 8562 8564 +4704 111 8566 8565 8567 +4705 111 8569 8568 8570 +4706 111 8572 8571 8573 +4707 111 8575 8574 8576 +4708 111 8578 8577 8579 +4709 111 8581 8580 8582 +4710 111 8584 8583 8585 +4711 111 8587 8586 8588 +4712 111 8590 8589 8591 +4713 111 8593 8592 8594 +4714 111 8596 8595 8597 +4715 111 8599 8598 8600 +4716 111 8602 8601 8603 +4717 111 8605 8604 8606 +4718 111 8608 8607 8609 +4719 111 8611 8610 8612 +4720 111 8614 8613 8615 +4721 111 8617 8616 8618 +4722 111 8620 8619 8621 +4723 111 8623 8622 8624 +4724 111 8626 8625 8627 +4725 111 8629 8628 8630 +4726 111 8632 8631 8633 +4727 111 8635 8634 8636 +4728 111 8638 8637 8639 +4729 111 8641 8640 8642 +4730 111 8644 8643 8645 +4731 111 8647 8646 8648 +4732 111 8650 8649 8651 +4733 111 8653 8652 8654 +4734 111 8656 8655 8657 +4735 111 8659 8658 8660 +4736 111 8662 8661 8663 +4737 111 8665 8664 8666 +4738 111 8668 8667 8669 +4739 111 8671 8670 8672 +4740 111 8674 8673 8675 +4741 111 8677 8676 8678 +4742 111 8680 8679 8681 +4743 111 8683 8682 8684 +4744 111 8686 8685 8687 +4745 111 8689 8688 8690 +4746 111 8692 8691 8693 +4747 111 8695 8694 8696 +4748 111 8698 8697 8699 +4749 111 8701 8700 8702 +4750 111 8704 8703 8705 +4751 111 8707 8706 8708 +4752 111 8710 8709 8711 +4753 111 8713 8712 8714 +4754 111 8716 8715 8717 +4755 111 8719 8718 8720 +4756 111 8722 8721 8723 +4757 111 8725 8724 8726 +4758 111 8728 8727 8729 +4759 111 8731 8730 8732 +4760 111 8734 8733 8735 +4761 111 8737 8736 8738 +4762 111 8740 8739 8741 +4763 111 8743 8742 8744 +4764 111 8746 8745 8747 +4765 111 8749 8748 8750 +4766 111 8752 8751 8753 +4767 111 8755 8754 8756 +4768 111 8758 8757 8759 +4769 111 8761 8760 8762 +4770 111 8764 8763 8765 +4771 111 8767 8766 8768 +4772 111 8770 8769 8771 +4773 111 8773 8772 8774 +4774 111 8776 8775 8777 +4775 111 8779 8778 8780 +4776 111 8782 8781 8783 +4777 111 8785 8784 8786 +4778 111 8788 8787 8789 +4779 111 8791 8790 8792 +4780 111 8794 8793 8795 +4781 111 8797 8796 8798 +4782 111 8800 8799 8801 +4783 111 8803 8802 8804 +4784 111 8806 8805 8807 +4785 111 8809 8808 8810 +4786 111 8812 8811 8813 +4787 111 8815 8814 8816 +4788 111 8818 8817 8819 +4789 111 8821 8820 8822 +4790 111 8824 8823 8825 +4791 111 8827 8826 8828 +4792 111 8830 8829 8831 +4793 111 8833 8832 8834 +4794 111 8836 8835 8837 +4795 111 8839 8838 8840 +4796 111 8842 8841 8843 +4797 111 8845 8844 8846 +4798 111 8848 8847 8849 +4799 111 8851 8850 8852 +4800 111 8854 8853 8855 +4801 111 8857 8856 8858 +4802 111 8860 8859 8861 +4803 111 8863 8862 8864 +4804 111 8866 8865 8867 +4805 111 8869 8868 8870 +4806 111 8872 8871 8873 +4807 111 8875 8874 8876 +4808 111 8878 8877 8879 +4809 111 8881 8880 8882 +4810 111 8884 8883 8885 +4811 111 8887 8886 8888 +4812 111 8890 8889 8891 +4813 111 8893 8892 8894 +4814 111 8896 8895 8897 +4815 111 8899 8898 8900 +4816 111 8902 8901 8903 +4817 111 8905 8904 8906 +4818 111 8908 8907 8909 +4819 111 8911 8910 8912 +4820 111 8914 8913 8915 +4821 111 8917 8916 8918 +4822 111 8920 8919 8921 +4823 111 8923 8922 8924 +4824 111 8926 8925 8927 +4825 111 8929 8928 8930 +4826 111 8932 8931 8933 +4827 111 8935 8934 8936 +4828 111 8938 8937 8939 +4829 111 8941 8940 8942 +4830 111 8944 8943 8945 +4831 111 8947 8946 8948 +4832 111 8950 8949 8951 +4833 111 8953 8952 8954 +4834 111 8956 8955 8957 +4835 111 8959 8958 8960 +4836 111 8962 8961 8963 +4837 111 8965 8964 8966 +4838 111 8968 8967 8969 +4839 111 8971 8970 8972 +4840 111 8974 8973 8975 +4841 111 8977 8976 8978 +4842 111 8980 8979 8981 +4843 111 8983 8982 8984 +4844 111 8986 8985 8987 +4845 111 8989 8988 8990 +4846 111 8992 8991 8993 +4847 111 8995 8994 8996 +4848 111 8998 8997 8999 +4849 111 9001 9000 9002 +4850 111 9004 9003 9005 +4851 111 9007 9006 9008 +4852 111 9010 9009 9011 +4853 111 9013 9012 9014 +4854 111 9016 9015 9017 +4855 111 9019 9018 9020 +4856 111 9022 9021 9023 +4857 111 9025 9024 9026 +4858 111 9028 9027 9029 +4859 111 9031 9030 9032 +4860 111 9034 9033 9035 +4861 111 9037 9036 9038 +4862 111 9040 9039 9041 +4863 111 9043 9042 9044 +4864 111 9046 9045 9047 +4865 111 9049 9048 9050 +4866 111 9052 9051 9053 +4867 111 9055 9054 9056 +4868 111 9058 9057 9059 +4869 111 9061 9060 9062 +4870 111 9064 9063 9065 +4871 111 9067 9066 9068 +4872 111 9070 9069 9071 +4873 111 9073 9072 9074 +4874 111 9076 9075 9077 +4875 111 9079 9078 9080 +4876 111 9082 9081 9083 +4877 111 9085 9084 9086 +4878 111 9088 9087 9089 +4879 111 9091 9090 9092 +4880 111 9094 9093 9095 +4881 111 9097 9096 9098 +4882 111 9100 9099 9101 +4883 111 9103 9102 9104 +4884 111 9106 9105 9107 +4885 111 9109 9108 9110 +4886 111 9112 9111 9113 +4887 111 9115 9114 9116 +4888 111 9118 9117 9119 +4889 111 9121 9120 9122 +4890 111 9124 9123 9125 +4891 111 9127 9126 9128 +4892 111 9130 9129 9131 +4893 111 9133 9132 9134 +4894 111 9136 9135 9137 +4895 111 9139 9138 9140 +4896 111 9142 9141 9143 +4897 111 9145 9144 9146 +4898 111 9148 9147 9149 +4899 111 9151 9150 9152 +4900 111 9154 9153 9155 +4901 111 9157 9156 9158 +4902 111 9160 9159 9161 +4903 111 9163 9162 9164 +4904 111 9166 9165 9167 +4905 111 9169 9168 9170 +4906 111 9172 9171 9173 +4907 111 9175 9174 9176 +4908 111 9178 9177 9179 +4909 111 9181 9180 9182 +4910 111 9184 9183 9185 +4911 111 9187 9186 9188 +4912 111 9190 9189 9191 +4913 111 9193 9192 9194 +4914 111 9196 9195 9197 +4915 111 9199 9198 9200 +4916 111 9202 9201 9203 +4917 111 9205 9204 9206 +4918 111 9208 9207 9209 +4919 111 9211 9210 9212 +4920 111 9214 9213 9215 +4921 111 9217 9216 9218 +4922 111 9220 9219 9221 +4923 111 9223 9222 9224 +4924 111 9226 9225 9227 +4925 111 9229 9228 9230 +4926 111 9232 9231 9233 +4927 111 9235 9234 9236 +4928 111 9238 9237 9239 +4929 111 9241 9240 9242 +4930 111 9244 9243 9245 +4931 111 9247 9246 9248 +4932 111 9250 9249 9251 +4933 111 9253 9252 9254 +4934 111 9256 9255 9257 +4935 111 9259 9258 9260 +4936 111 9262 9261 9263 +4937 111 9265 9264 9266 +4938 111 9268 9267 9269 +4939 111 9271 9270 9272 +4940 111 9274 9273 9275 +4941 111 9277 9276 9278 +4942 111 9280 9279 9281 +4943 111 9283 9282 9284 +4944 111 9286 9285 9287 +4945 111 9289 9288 9290 +4946 111 9292 9291 9293 +4947 111 9295 9294 9296 +4948 111 9298 9297 9299 +4949 111 9301 9300 9302 +4950 111 9304 9303 9305 +4951 111 9307 9306 9308 +4952 111 9310 9309 9311 +4953 111 9313 9312 9314 +4954 111 9316 9315 9317 +4955 111 9319 9318 9320 +4956 111 9322 9321 9323 +4957 111 9325 9324 9326 +4958 111 9328 9327 9329 +4959 111 9331 9330 9332 +4960 111 9334 9333 9335 +4961 111 9337 9336 9338 +4962 111 9340 9339 9341 +4963 111 9343 9342 9344 +4964 111 9346 9345 9347 +4965 111 9349 9348 9350 +4966 111 9352 9351 9353 +4967 111 9355 9354 9356 +4968 111 9358 9357 9359 +4969 111 9361 9360 9362 +4970 111 9364 9363 9365 +4971 111 9367 9366 9368 +4972 111 9370 9369 9371 +4973 111 9373 9372 9374 +4974 111 9376 9375 9377 +4975 111 9379 9378 9380 +4976 111 9382 9381 9383 +4977 111 9385 9384 9386 +4978 111 9388 9387 9389 +4979 111 9391 9390 9392 +4980 111 9394 9393 9395 +4981 111 9397 9396 9398 +4982 111 9400 9399 9401 +4983 111 9403 9402 9404 +4984 111 9406 9405 9407 +4985 111 9409 9408 9410 +4986 111 9412 9411 9413 +4987 111 9415 9414 9416 +4988 111 9418 9417 9419 +4989 111 9421 9420 9422 +4990 111 9424 9423 9425 +4991 111 9427 9426 9428 +4992 111 9430 9429 9431 +4993 111 9433 9432 9434 +4994 111 9436 9435 9437 +4995 111 9439 9438 9440 +4996 111 9442 9441 9443 +4997 111 9445 9444 9446 +4998 111 9448 9447 9449 +4999 111 9451 9450 9452 +5000 111 9454 9453 9455 +5001 111 9457 9456 9458 +5002 111 9460 9459 9461 +5003 111 9463 9462 9464 +5004 111 9466 9465 9467 +5005 111 9469 9468 9470 +5006 111 9472 9471 9473 +5007 111 9475 9474 9476 +5008 111 9478 9477 9479 +5009 111 9481 9480 9482 +5010 111 9484 9483 9485 +5011 111 9487 9486 9488 +5012 111 9490 9489 9491 +5013 111 9493 9492 9494 +5014 111 9496 9495 9497 +5015 111 9499 9498 9500 +5016 111 9502 9501 9503 +5017 111 9505 9504 9506 +5018 111 9508 9507 9509 +5019 111 9511 9510 9512 +5020 111 9514 9513 9515 +5021 111 9517 9516 9518 +5022 111 9520 9519 9521 +5023 111 9523 9522 9524 +5024 111 9526 9525 9527 +5025 111 9529 9528 9530 +5026 111 9532 9531 9533 +5027 111 9535 9534 9536 +5028 111 9538 9537 9539 +5029 111 9541 9540 9542 +5030 111 9544 9543 9545 +5031 111 9547 9546 9548 +5032 111 9550 9549 9551 +5033 111 9553 9552 9554 +5034 111 9556 9555 9557 +5035 111 9559 9558 9560 +5036 111 9562 9561 9563 +5037 111 9565 9564 9566 +5038 111 9568 9567 9569 +5039 111 9571 9570 9572 +5040 111 9574 9573 9575 +5041 111 9577 9576 9578 +5042 111 9580 9579 9581 +5043 111 9583 9582 9584 +5044 111 9586 9585 9587 +5045 111 9589 9588 9590 +5046 111 9592 9591 9593 +5047 111 9595 9594 9596 +5048 111 9598 9597 9599 +5049 111 9601 9600 9602 +5050 111 9604 9603 9605 +5051 111 9607 9606 9608 +5052 111 9610 9609 9611 +5053 111 9613 9612 9614 +5054 111 9616 9615 9617 +5055 111 9619 9618 9620 +5056 111 9622 9621 9623 +5057 111 9625 9624 9626 +5058 111 9628 9627 9629 +5059 111 9631 9630 9632 +5060 111 9634 9633 9635 +5061 111 9637 9636 9638 +5062 111 9640 9639 9641 +5063 111 9643 9642 9644 +5064 111 9646 9645 9647 +5065 111 9649 9648 9650 +5066 111 9652 9651 9653 +5067 111 9655 9654 9656 +5068 111 9658 9657 9659 +5069 111 9661 9660 9662 +5070 111 9664 9663 9665 +5071 111 9667 9666 9668 +5072 111 9670 9669 9671 +5073 111 9673 9672 9674 +5074 111 9676 9675 9677 +5075 111 9679 9678 9680 +5076 111 9682 9681 9683 +5077 111 9685 9684 9686 +5078 111 9688 9687 9689 +5079 111 9691 9690 9692 +5080 111 9694 9693 9695 +5081 111 9697 9696 9698 +5082 111 9700 9699 9701 +5083 111 9703 9702 9704 +5084 111 9706 9705 9707 +5085 111 9709 9708 9710 +5086 111 9712 9711 9713 +5087 111 9715 9714 9716 +5088 111 9718 9717 9719 +5089 111 9721 9720 9722 +5090 111 9724 9723 9725 +5091 111 9727 9726 9728 +5092 111 9730 9729 9731 +5093 111 9733 9732 9734 +5094 111 9736 9735 9737 Dihedrals diff --git a/examples/amoeba/data.water_box.amoeba b/examples/amoeba/data.water_box.amoeba index 94b507f765..54cabb7a2f 100644 --- a/examples/amoeba/data.water_box.amoeba +++ b/examples/amoeba/data.water_box.amoeba @@ -1103,222 +1103,222 @@ Bonds Angles -1 1 3 1 2 -2 1 6 4 5 -3 1 9 7 8 -4 1 12 10 11 -5 1 15 13 14 -6 1 18 16 17 -7 1 21 19 20 -8 1 24 22 23 -9 1 27 25 26 -10 1 30 28 29 -11 1 33 31 32 -12 1 36 34 35 -13 1 39 37 38 -14 1 42 40 41 -15 1 45 43 44 -16 1 48 46 47 -17 1 51 49 50 -18 1 54 52 53 -19 1 57 55 56 -20 1 60 58 59 -21 1 63 61 62 -22 1 66 64 65 -23 1 69 67 68 -24 1 72 70 71 -25 1 75 73 74 -26 1 78 76 77 -27 1 81 79 80 -28 1 84 82 83 -29 1 87 85 86 -30 1 90 88 89 -31 1 93 91 92 -32 1 96 94 95 -33 1 99 97 98 -34 1 102 100 101 -35 1 105 103 104 -36 1 108 106 107 -37 1 111 109 110 -38 1 114 112 113 -39 1 117 115 116 -40 1 120 118 119 -41 1 123 121 122 -42 1 126 124 125 -43 1 129 127 128 -44 1 132 130 131 -45 1 135 133 134 -46 1 138 136 137 -47 1 141 139 140 -48 1 144 142 143 -49 1 147 145 146 -50 1 150 148 149 -51 1 153 151 152 -52 1 156 154 155 -53 1 159 157 158 -54 1 162 160 161 -55 1 165 163 164 -56 1 168 166 167 -57 1 171 169 170 -58 1 174 172 173 -59 1 177 175 176 -60 1 180 178 179 -61 1 183 181 182 -62 1 186 184 185 -63 1 189 187 188 -64 1 192 190 191 -65 1 195 193 194 -66 1 198 196 197 -67 1 201 199 200 -68 1 204 202 203 -69 1 207 205 206 -70 1 210 208 209 -71 1 213 211 212 -72 1 216 214 215 -73 1 219 217 218 -74 1 222 220 221 -75 1 225 223 224 -76 1 228 226 227 -77 1 231 229 230 -78 1 234 232 233 -79 1 237 235 236 -80 1 240 238 239 -81 1 243 241 242 -82 1 246 244 245 -83 1 249 247 248 -84 1 252 250 251 -85 1 255 253 254 -86 1 258 256 257 -87 1 261 259 260 -88 1 264 262 263 -89 1 267 265 266 -90 1 270 268 269 -91 1 273 271 272 -92 1 276 274 275 -93 1 279 277 278 -94 1 282 280 281 -95 1 285 283 284 -96 1 288 286 287 -97 1 291 289 290 -98 1 294 292 293 -99 1 297 295 296 -100 1 300 298 299 -101 1 303 301 302 -102 1 306 304 305 -103 1 309 307 308 -104 1 312 310 311 -105 1 315 313 314 -106 1 318 316 317 -107 1 321 319 320 -108 1 324 322 323 -109 1 327 325 326 -110 1 330 328 329 -111 1 333 331 332 -112 1 336 334 335 -113 1 339 337 338 -114 1 342 340 341 -115 1 345 343 344 -116 1 348 346 347 -117 1 351 349 350 -118 1 354 352 353 -119 1 357 355 356 -120 1 360 358 359 -121 1 363 361 362 -122 1 366 364 365 -123 1 369 367 368 -124 1 372 370 371 -125 1 375 373 374 -126 1 378 376 377 -127 1 381 379 380 -128 1 384 382 383 -129 1 387 385 386 -130 1 390 388 389 -131 1 393 391 392 -132 1 396 394 395 -133 1 399 397 398 -134 1 402 400 401 -135 1 405 403 404 -136 1 408 406 407 -137 1 411 409 410 -138 1 414 412 413 -139 1 417 415 416 -140 1 420 418 419 -141 1 423 421 422 -142 1 426 424 425 -143 1 429 427 428 -144 1 432 430 431 -145 1 435 433 434 -146 1 438 436 437 -147 1 441 439 440 -148 1 444 442 443 -149 1 447 445 446 -150 1 450 448 449 -151 1 453 451 452 -152 1 456 454 455 -153 1 459 457 458 -154 1 462 460 461 -155 1 465 463 464 -156 1 468 466 467 -157 1 471 469 470 -158 1 474 472 473 -159 1 477 475 476 -160 1 480 478 479 -161 1 483 481 482 -162 1 486 484 485 -163 1 489 487 488 -164 1 492 490 491 -165 1 495 493 494 -166 1 498 496 497 -167 1 501 499 500 -168 1 504 502 503 -169 1 507 505 506 -170 1 510 508 509 -171 1 513 511 512 -172 1 516 514 515 -173 1 519 517 518 -174 1 522 520 521 -175 1 525 523 524 -176 1 528 526 527 -177 1 531 529 530 -178 1 534 532 533 -179 1 537 535 536 -180 1 540 538 539 -181 1 543 541 542 -182 1 546 544 545 -183 1 549 547 548 -184 1 552 550 551 -185 1 555 553 554 -186 1 558 556 557 -187 1 561 559 560 -188 1 564 562 563 -189 1 567 565 566 -190 1 570 568 569 -191 1 573 571 572 -192 1 576 574 575 -193 1 579 577 578 -194 1 582 580 581 -195 1 585 583 584 -196 1 588 586 587 -197 1 591 589 590 -198 1 594 592 593 -199 1 597 595 596 -200 1 600 598 599 -201 1 603 601 602 -202 1 606 604 605 -203 1 609 607 608 -204 1 612 610 611 -205 1 615 613 614 -206 1 618 616 617 -207 1 621 619 620 -208 1 624 622 623 -209 1 627 625 626 -210 1 630 628 629 -211 1 633 631 632 -212 1 636 634 635 -213 1 639 637 638 -214 1 642 640 641 -215 1 645 643 644 -216 1 648 646 647 +1 1 2 1 3 +2 1 5 4 6 +3 1 8 7 9 +4 1 11 10 12 +5 1 14 13 15 +6 1 17 16 18 +7 1 20 19 21 +8 1 23 22 24 +9 1 26 25 27 +10 1 29 28 30 +11 1 32 31 33 +12 1 35 34 36 +13 1 38 37 39 +14 1 41 40 42 +15 1 44 43 45 +16 1 47 46 48 +17 1 50 49 51 +18 1 53 52 54 +19 1 56 55 57 +20 1 59 58 60 +21 1 62 61 63 +22 1 65 64 66 +23 1 68 67 69 +24 1 71 70 72 +25 1 74 73 75 +26 1 77 76 78 +27 1 80 79 81 +28 1 83 82 84 +29 1 86 85 87 +30 1 89 88 90 +31 1 92 91 93 +32 1 95 94 96 +33 1 98 97 99 +34 1 101 100 102 +35 1 104 103 105 +36 1 107 106 108 +37 1 110 109 111 +38 1 113 112 114 +39 1 116 115 117 +40 1 119 118 120 +41 1 122 121 123 +42 1 125 124 126 +43 1 128 127 129 +44 1 131 130 132 +45 1 134 133 135 +46 1 137 136 138 +47 1 140 139 141 +48 1 143 142 144 +49 1 146 145 147 +50 1 149 148 150 +51 1 152 151 153 +52 1 155 154 156 +53 1 158 157 159 +54 1 161 160 162 +55 1 164 163 165 +56 1 167 166 168 +57 1 170 169 171 +58 1 173 172 174 +59 1 176 175 177 +60 1 179 178 180 +61 1 182 181 183 +62 1 185 184 186 +63 1 188 187 189 +64 1 191 190 192 +65 1 194 193 195 +66 1 197 196 198 +67 1 200 199 201 +68 1 203 202 204 +69 1 206 205 207 +70 1 209 208 210 +71 1 212 211 213 +72 1 215 214 216 +73 1 218 217 219 +74 1 221 220 222 +75 1 224 223 225 +76 1 227 226 228 +77 1 230 229 231 +78 1 233 232 234 +79 1 236 235 237 +80 1 239 238 240 +81 1 242 241 243 +82 1 245 244 246 +83 1 248 247 249 +84 1 251 250 252 +85 1 254 253 255 +86 1 257 256 258 +87 1 260 259 261 +88 1 263 262 264 +89 1 266 265 267 +90 1 269 268 270 +91 1 272 271 273 +92 1 275 274 276 +93 1 278 277 279 +94 1 281 280 282 +95 1 284 283 285 +96 1 287 286 288 +97 1 290 289 291 +98 1 293 292 294 +99 1 296 295 297 +100 1 299 298 300 +101 1 302 301 303 +102 1 305 304 306 +103 1 308 307 309 +104 1 311 310 312 +105 1 314 313 315 +106 1 317 316 318 +107 1 320 319 321 +108 1 323 322 324 +109 1 326 325 327 +110 1 329 328 330 +111 1 332 331 333 +112 1 335 334 336 +113 1 338 337 339 +114 1 341 340 342 +115 1 344 343 345 +116 1 347 346 348 +117 1 350 349 351 +118 1 353 352 354 +119 1 356 355 357 +120 1 359 358 360 +121 1 362 361 363 +122 1 365 364 366 +123 1 368 367 369 +124 1 371 370 372 +125 1 374 373 375 +126 1 377 376 378 +127 1 380 379 381 +128 1 383 382 384 +129 1 386 385 387 +130 1 389 388 390 +131 1 392 391 393 +132 1 395 394 396 +133 1 398 397 399 +134 1 401 400 402 +135 1 404 403 405 +136 1 407 406 408 +137 1 410 409 411 +138 1 413 412 414 +139 1 416 415 417 +140 1 419 418 420 +141 1 422 421 423 +142 1 425 424 426 +143 1 428 427 429 +144 1 431 430 432 +145 1 434 433 435 +146 1 437 436 438 +147 1 440 439 441 +148 1 443 442 444 +149 1 446 445 447 +150 1 449 448 450 +151 1 452 451 453 +152 1 455 454 456 +153 1 458 457 459 +154 1 461 460 462 +155 1 464 463 465 +156 1 467 466 468 +157 1 470 469 471 +158 1 473 472 474 +159 1 476 475 477 +160 1 479 478 480 +161 1 482 481 483 +162 1 485 484 486 +163 1 488 487 489 +164 1 491 490 492 +165 1 494 493 495 +166 1 497 496 498 +167 1 500 499 501 +168 1 503 502 504 +169 1 506 505 507 +170 1 509 508 510 +171 1 512 511 513 +172 1 515 514 516 +173 1 518 517 519 +174 1 521 520 522 +175 1 524 523 525 +176 1 527 526 528 +177 1 530 529 531 +178 1 533 532 534 +179 1 536 535 537 +180 1 539 538 540 +181 1 542 541 543 +182 1 545 544 546 +183 1 548 547 549 +184 1 551 550 552 +185 1 554 553 555 +186 1 557 556 558 +187 1 560 559 561 +188 1 563 562 564 +189 1 566 565 567 +190 1 569 568 570 +191 1 572 571 573 +192 1 575 574 576 +193 1 578 577 579 +194 1 581 580 582 +195 1 584 583 585 +196 1 587 586 588 +197 1 590 589 591 +198 1 593 592 594 +199 1 596 595 597 +200 1 599 598 600 +201 1 602 601 603 +202 1 605 604 606 +203 1 608 607 609 +204 1 611 610 612 +205 1 614 613 615 +206 1 617 616 618 +207 1 620 619 621 +208 1 623 622 624 +209 1 626 625 627 +210 1 629 628 630 +211 1 632 631 633 +212 1 635 634 636 +213 1 638 637 639 +214 1 641 640 642 +215 1 644 643 645 +216 1 647 646 648 Bond Coeffs diff --git a/examples/amoeba/data.water_box.hippo b/examples/amoeba/data.water_box.hippo index d2e38989be..8c6511ea5f 100644 --- a/examples/amoeba/data.water_box.hippo +++ b/examples/amoeba/data.water_box.hippo @@ -1103,222 +1103,222 @@ Bonds Angles -1 1 3 1 2 -2 1 6 4 5 -3 1 9 7 8 -4 1 12 10 11 -5 1 15 13 14 -6 1 18 16 17 -7 1 21 19 20 -8 1 24 22 23 -9 1 27 25 26 -10 1 30 28 29 -11 1 33 31 32 -12 1 36 34 35 -13 1 39 37 38 -14 1 42 40 41 -15 1 45 43 44 -16 1 48 46 47 -17 1 51 49 50 -18 1 54 52 53 -19 1 57 55 56 -20 1 60 58 59 -21 1 63 61 62 -22 1 66 64 65 -23 1 69 67 68 -24 1 72 70 71 -25 1 75 73 74 -26 1 78 76 77 -27 1 81 79 80 -28 1 84 82 83 -29 1 87 85 86 -30 1 90 88 89 -31 1 93 91 92 -32 1 96 94 95 -33 1 99 97 98 -34 1 102 100 101 -35 1 105 103 104 -36 1 108 106 107 -37 1 111 109 110 -38 1 114 112 113 -39 1 117 115 116 -40 1 120 118 119 -41 1 123 121 122 -42 1 126 124 125 -43 1 129 127 128 -44 1 132 130 131 -45 1 135 133 134 -46 1 138 136 137 -47 1 141 139 140 -48 1 144 142 143 -49 1 147 145 146 -50 1 150 148 149 -51 1 153 151 152 -52 1 156 154 155 -53 1 159 157 158 -54 1 162 160 161 -55 1 165 163 164 -56 1 168 166 167 -57 1 171 169 170 -58 1 174 172 173 -59 1 177 175 176 -60 1 180 178 179 -61 1 183 181 182 -62 1 186 184 185 -63 1 189 187 188 -64 1 192 190 191 -65 1 195 193 194 -66 1 198 196 197 -67 1 201 199 200 -68 1 204 202 203 -69 1 207 205 206 -70 1 210 208 209 -71 1 213 211 212 -72 1 216 214 215 -73 1 219 217 218 -74 1 222 220 221 -75 1 225 223 224 -76 1 228 226 227 -77 1 231 229 230 -78 1 234 232 233 -79 1 237 235 236 -80 1 240 238 239 -81 1 243 241 242 -82 1 246 244 245 -83 1 249 247 248 -84 1 252 250 251 -85 1 255 253 254 -86 1 258 256 257 -87 1 261 259 260 -88 1 264 262 263 -89 1 267 265 266 -90 1 270 268 269 -91 1 273 271 272 -92 1 276 274 275 -93 1 279 277 278 -94 1 282 280 281 -95 1 285 283 284 -96 1 288 286 287 -97 1 291 289 290 -98 1 294 292 293 -99 1 297 295 296 -100 1 300 298 299 -101 1 303 301 302 -102 1 306 304 305 -103 1 309 307 308 -104 1 312 310 311 -105 1 315 313 314 -106 1 318 316 317 -107 1 321 319 320 -108 1 324 322 323 -109 1 327 325 326 -110 1 330 328 329 -111 1 333 331 332 -112 1 336 334 335 -113 1 339 337 338 -114 1 342 340 341 -115 1 345 343 344 -116 1 348 346 347 -117 1 351 349 350 -118 1 354 352 353 -119 1 357 355 356 -120 1 360 358 359 -121 1 363 361 362 -122 1 366 364 365 -123 1 369 367 368 -124 1 372 370 371 -125 1 375 373 374 -126 1 378 376 377 -127 1 381 379 380 -128 1 384 382 383 -129 1 387 385 386 -130 1 390 388 389 -131 1 393 391 392 -132 1 396 394 395 -133 1 399 397 398 -134 1 402 400 401 -135 1 405 403 404 -136 1 408 406 407 -137 1 411 409 410 -138 1 414 412 413 -139 1 417 415 416 -140 1 420 418 419 -141 1 423 421 422 -142 1 426 424 425 -143 1 429 427 428 -144 1 432 430 431 -145 1 435 433 434 -146 1 438 436 437 -147 1 441 439 440 -148 1 444 442 443 -149 1 447 445 446 -150 1 450 448 449 -151 1 453 451 452 -152 1 456 454 455 -153 1 459 457 458 -154 1 462 460 461 -155 1 465 463 464 -156 1 468 466 467 -157 1 471 469 470 -158 1 474 472 473 -159 1 477 475 476 -160 1 480 478 479 -161 1 483 481 482 -162 1 486 484 485 -163 1 489 487 488 -164 1 492 490 491 -165 1 495 493 494 -166 1 498 496 497 -167 1 501 499 500 -168 1 504 502 503 -169 1 507 505 506 -170 1 510 508 509 -171 1 513 511 512 -172 1 516 514 515 -173 1 519 517 518 -174 1 522 520 521 -175 1 525 523 524 -176 1 528 526 527 -177 1 531 529 530 -178 1 534 532 533 -179 1 537 535 536 -180 1 540 538 539 -181 1 543 541 542 -182 1 546 544 545 -183 1 549 547 548 -184 1 552 550 551 -185 1 555 553 554 -186 1 558 556 557 -187 1 561 559 560 -188 1 564 562 563 -189 1 567 565 566 -190 1 570 568 569 -191 1 573 571 572 -192 1 576 574 575 -193 1 579 577 578 -194 1 582 580 581 -195 1 585 583 584 -196 1 588 586 587 -197 1 591 589 590 -198 1 594 592 593 -199 1 597 595 596 -200 1 600 598 599 -201 1 603 601 602 -202 1 606 604 605 -203 1 609 607 608 -204 1 612 610 611 -205 1 615 613 614 -206 1 618 616 617 -207 1 621 619 620 -208 1 624 622 623 -209 1 627 625 626 -210 1 630 628 629 -211 1 633 631 632 -212 1 636 634 635 -213 1 639 637 638 -214 1 642 640 641 -215 1 645 643 644 -216 1 648 646 647 +1 1 2 1 3 +2 1 5 4 6 +3 1 8 7 9 +4 1 11 10 12 +5 1 14 13 15 +6 1 17 16 18 +7 1 20 19 21 +8 1 23 22 24 +9 1 26 25 27 +10 1 29 28 30 +11 1 32 31 33 +12 1 35 34 36 +13 1 38 37 39 +14 1 41 40 42 +15 1 44 43 45 +16 1 47 46 48 +17 1 50 49 51 +18 1 53 52 54 +19 1 56 55 57 +20 1 59 58 60 +21 1 62 61 63 +22 1 65 64 66 +23 1 68 67 69 +24 1 71 70 72 +25 1 74 73 75 +26 1 77 76 78 +27 1 80 79 81 +28 1 83 82 84 +29 1 86 85 87 +30 1 89 88 90 +31 1 92 91 93 +32 1 95 94 96 +33 1 98 97 99 +34 1 101 100 102 +35 1 104 103 105 +36 1 107 106 108 +37 1 110 109 111 +38 1 113 112 114 +39 1 116 115 117 +40 1 119 118 120 +41 1 122 121 123 +42 1 125 124 126 +43 1 128 127 129 +44 1 131 130 132 +45 1 134 133 135 +46 1 137 136 138 +47 1 140 139 141 +48 1 143 142 144 +49 1 146 145 147 +50 1 149 148 150 +51 1 152 151 153 +52 1 155 154 156 +53 1 158 157 159 +54 1 161 160 162 +55 1 164 163 165 +56 1 167 166 168 +57 1 170 169 171 +58 1 173 172 174 +59 1 176 175 177 +60 1 179 178 180 +61 1 182 181 183 +62 1 185 184 186 +63 1 188 187 189 +64 1 191 190 192 +65 1 194 193 195 +66 1 197 196 198 +67 1 200 199 201 +68 1 203 202 204 +69 1 206 205 207 +70 1 209 208 210 +71 1 212 211 213 +72 1 215 214 216 +73 1 218 217 219 +74 1 221 220 222 +75 1 224 223 225 +76 1 227 226 228 +77 1 230 229 231 +78 1 233 232 234 +79 1 236 235 237 +80 1 239 238 240 +81 1 242 241 243 +82 1 245 244 246 +83 1 248 247 249 +84 1 251 250 252 +85 1 254 253 255 +86 1 257 256 258 +87 1 260 259 261 +88 1 263 262 264 +89 1 266 265 267 +90 1 269 268 270 +91 1 272 271 273 +92 1 275 274 276 +93 1 278 277 279 +94 1 281 280 282 +95 1 284 283 285 +96 1 287 286 288 +97 1 290 289 291 +98 1 293 292 294 +99 1 296 295 297 +100 1 299 298 300 +101 1 302 301 303 +102 1 305 304 306 +103 1 308 307 309 +104 1 311 310 312 +105 1 314 313 315 +106 1 317 316 318 +107 1 320 319 321 +108 1 323 322 324 +109 1 326 325 327 +110 1 329 328 330 +111 1 332 331 333 +112 1 335 334 336 +113 1 338 337 339 +114 1 341 340 342 +115 1 344 343 345 +116 1 347 346 348 +117 1 350 349 351 +118 1 353 352 354 +119 1 356 355 357 +120 1 359 358 360 +121 1 362 361 363 +122 1 365 364 366 +123 1 368 367 369 +124 1 371 370 372 +125 1 374 373 375 +126 1 377 376 378 +127 1 380 379 381 +128 1 383 382 384 +129 1 386 385 387 +130 1 389 388 390 +131 1 392 391 393 +132 1 395 394 396 +133 1 398 397 399 +134 1 401 400 402 +135 1 404 403 405 +136 1 407 406 408 +137 1 410 409 411 +138 1 413 412 414 +139 1 416 415 417 +140 1 419 418 420 +141 1 422 421 423 +142 1 425 424 426 +143 1 428 427 429 +144 1 431 430 432 +145 1 434 433 435 +146 1 437 436 438 +147 1 440 439 441 +148 1 443 442 444 +149 1 446 445 447 +150 1 449 448 450 +151 1 452 451 453 +152 1 455 454 456 +153 1 458 457 459 +154 1 461 460 462 +155 1 464 463 465 +156 1 467 466 468 +157 1 470 469 471 +158 1 473 472 474 +159 1 476 475 477 +160 1 479 478 480 +161 1 482 481 483 +162 1 485 484 486 +163 1 488 487 489 +164 1 491 490 492 +165 1 494 493 495 +166 1 497 496 498 +167 1 500 499 501 +168 1 503 502 504 +169 1 506 505 507 +170 1 509 508 510 +171 1 512 511 513 +172 1 515 514 516 +173 1 518 517 519 +174 1 521 520 522 +175 1 524 523 525 +176 1 527 526 528 +177 1 530 529 531 +178 1 533 532 534 +179 1 536 535 537 +180 1 539 538 540 +181 1 542 541 543 +182 1 545 544 546 +183 1 548 547 549 +184 1 551 550 552 +185 1 554 553 555 +186 1 557 556 558 +187 1 560 559 561 +188 1 563 562 564 +189 1 566 565 567 +190 1 569 568 570 +191 1 572 571 573 +192 1 575 574 576 +193 1 578 577 579 +194 1 581 580 582 +195 1 584 583 585 +196 1 587 586 588 +197 1 590 589 591 +198 1 593 592 594 +199 1 596 595 597 +200 1 599 598 600 +201 1 602 601 603 +202 1 605 604 606 +203 1 608 607 609 +204 1 611 610 612 +205 1 614 613 615 +206 1 617 616 618 +207 1 620 619 621 +208 1 623 622 624 +209 1 626 625 627 +210 1 629 628 630 +211 1 632 631 633 +212 1 635 634 636 +213 1 638 637 639 +214 1 641 640 642 +215 1 644 643 645 +216 1 647 646 648 Bond Coeffs diff --git a/examples/amoeba/data.water_dimer.amoeba b/examples/amoeba/data.water_dimer.amoeba index cb853e35df..09c8aea3b3 100644 --- a/examples/amoeba/data.water_dimer.amoeba +++ b/examples/amoeba/data.water_dimer.amoeba @@ -33,8 +33,8 @@ Bonds Angles -1 1 3 1 2 -2 1 6 4 5 +1 1 2 1 3 +2 1 5 4 6 Bond Coeffs diff --git a/examples/amoeba/data.water_dimer.hippo b/examples/amoeba/data.water_dimer.hippo index 5cdd388a09..0264e7d8b0 100644 --- a/examples/amoeba/data.water_dimer.hippo +++ b/examples/amoeba/data.water_dimer.hippo @@ -33,8 +33,8 @@ Bonds Angles -1 1 3 1 2 -2 1 6 4 5 +1 1 2 1 3 +2 1 5 4 6 Bond Coeffs diff --git a/examples/amoeba/data.water_hexamer.amoeba b/examples/amoeba/data.water_hexamer.amoeba index 9197df6ccd..af84237336 100644 --- a/examples/amoeba/data.water_hexamer.amoeba +++ b/examples/amoeba/data.water_hexamer.amoeba @@ -53,12 +53,12 @@ Bonds Angles -1 1 3 1 2 -2 1 6 4 5 -3 1 9 7 8 -4 1 12 10 11 -5 1 15 13 14 -6 1 18 16 17 +1 1 2 1 3 +2 1 5 4 6 +3 1 8 7 9 +4 1 11 10 12 +5 1 14 13 15 +6 1 17 16 18 Bond Coeffs diff --git a/examples/amoeba/data.water_hexamer.hippo b/examples/amoeba/data.water_hexamer.hippo index a987f8cdb6..e44f2ca5f9 100644 --- a/examples/amoeba/data.water_hexamer.hippo +++ b/examples/amoeba/data.water_hexamer.hippo @@ -53,12 +53,12 @@ Bonds Angles -1 1 3 1 2 -2 1 6 4 5 -3 1 9 7 8 -4 1 12 10 11 -5 1 15 13 14 -6 1 18 16 17 +1 1 2 1 3 +2 1 5 4 6 +3 1 8 7 9 +4 1 11 10 12 +5 1 14 13 15 +6 1 17 16 18 Bond Coeffs diff --git a/examples/amoeba/in.water_box.amoeba b/examples/amoeba/in.water_box.amoeba index 3a37784f9d..c15a684d95 100644 --- a/examples/amoeba/in.water_box.amoeba +++ b/examples/amoeba/in.water_box.amoeba @@ -35,10 +35,10 @@ thermo_style custom step temp epair ebond eangle edihed eimp & # zero step run -#run 0 +run 0 # dynamics -thermo 1 -fix 1 all nve -run 100 +#thermo 1 +#fix 1 all nve +#run 100 diff --git a/examples/amoeba/in.water_box.hippo b/examples/amoeba/in.water_box.hippo index 8e1d9a8e70..df2f961b56 100644 --- a/examples/amoeba/in.water_box.hippo +++ b/examples/amoeba/in.water_box.hippo @@ -35,10 +35,10 @@ thermo_style custom step temp epair ebond eangle edihed eimp & # zero step run -#run 0 +run 0 # dynamics -thermo 1 -fix 1 all nve -run 100 +#thermo 1 +#fix 1 all nve +#run 100 diff --git a/examples/amoeba/in.water_hexamer.amoeba b/examples/amoeba/in.water_hexamer.amoeba index bc742f3089..eb16206f45 100644 --- a/examples/amoeba/in.water_hexamer.amoeba +++ b/examples/amoeba/in.water_hexamer.amoeba @@ -35,10 +35,10 @@ thermo_style custom step temp epair ebond eangle edihed eimp & # zero step run -#run 0 +run 0 # dynamics -thermo 1 -fix 1 all nve -run 100 +#thermo 1 +#fix 1 all nve +#run 100 diff --git a/examples/amoeba/in.water_hexamer.hippo b/examples/amoeba/in.water_hexamer.hippo index bb5cf9e910..1287a1f527 100644 --- a/examples/amoeba/in.water_hexamer.hippo +++ b/examples/amoeba/in.water_hexamer.hippo @@ -35,10 +35,10 @@ thermo_style custom step temp epair ebond eangle edihed eimp & # zero step run -#run 0 +run 0 # dynamics -thermo 1 -fix 1 all nve -run 100 +#thermo 1 +#fix 1 all nve +#run 100 From 82e5b46361b813a20e0336167852a1597307502e Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Mon, 11 Apr 2022 13:46:29 -0600 Subject: [PATCH 108/585] fix bug with xyz multipole axes --- src/AMOEBA/amoeba_utils.cpp | 177 +++++++++--------------------------- src/AMOEBA/pair_amoeba.h | 1 - 2 files changed, 41 insertions(+), 137 deletions(-) diff --git a/src/AMOEBA/amoeba_utils.cpp b/src/AMOEBA/amoeba_utils.cpp index 0550e20bfb..e5831f9348 100644 --- a/src/AMOEBA/amoeba_utils.cpp +++ b/src/AMOEBA/amoeba_utils.cpp @@ -30,9 +30,11 @@ enum{NOFRAME,ZONLY,ZTHENX,BISECTOR,ZBISECT,THREEFOLD}; /* ---------------------------------------------------------------------- kmpole performs one-time assignment of - xaxis,yaxis,zaxis multipole neighbors to each owned atom - sets polaxe and pole[13] multipole for each owned atom - NOTE: doesn't always do this identically to Tinker b/c atom order matters + xaxis,yaxis,zaxis multipole neighbors to each owned atom + any of the values can be 0 if not used + yaxis can later be negative due to chkpole() + also sets polaxe and pole[13] multipole for each owned atom + NOTE: may not always do this identically to Tinker b/c atom order matters ------------------------------------------------------------------------- */ void PairAmoeba::kmpole() @@ -65,14 +67,13 @@ void PairAmoeba::kmpole() for (i = 0; i < nlocal; i++) { itype = amtype[i]; nframe = nmultiframe[itype]; + + // flag is used to prevent matching multiple times + // only first match is used + flag = 0; - // DEBUG START - // create a sorted version of bond/angle neighs in special[][] - - //printf("BTAGS %d:",atom->tag[i]); - //for (j = 0; j < nspecial[i][0]; j++) printf(" %d",special[i][j]); - //printf("\n"); + // create a sorted version of bond/angle neighs from special[][] for (j = 0; j < nspecial[i][0]; j++) bondneigh[j] = special[i][j]; @@ -88,14 +89,6 @@ void PairAmoeba::kmpole() } } - //printf(" %d:",atom->tag[i]); - //for (j = 0; j < nspecial[i][0]; j++) printf(" %d",bondneigh[j]); - //printf("\n"); - - //printf("ATAGS %d:",atom->tag[i]); - //for (j = nspecial[i][0]; j < nspecial[i][1]; j++) printf(" %d",special[i][j]); - //printf("\n"); - for (j = nspecial[i][0]; j < nspecial[i][1]; j++) angleneigh[j] = special[i][j]; for (m = nspecial[i][0]; m < nspecial[i][1]; m++) { @@ -110,12 +103,6 @@ void PairAmoeba::kmpole() } } - //printf(" %d:",atom->tag[i]); - //for (j = nspecial[i][0]; j < nspecial[i][1]; j++) printf(" %d",angleneigh[j]); - //printf("\n"); - - // DEBUG STOP - // assign xyz axis and fpole via only 1-2 connected atoms for (iframe = 0; iframe < nframe; iframe++) { @@ -123,7 +110,6 @@ void PairAmoeba::kmpole() ytype = ypole[itype][iframe]; ztype = zpole[itype][iframe]; for (j12 = 0; j12 < nspecial[i][0]; j12++) { - //jneigh = special[i][j12]; jneigh = bondneigh[j12]; j = atom->map(jneigh); if (j < 0) @@ -132,15 +118,13 @@ void PairAmoeba::kmpole() if (jtype == ztype) { for (k12 = 0; k12 < nspecial[i][0]; k12++) { if (k12 == j12) continue; - //kneigh = special[i][k12]; kneigh = bondneigh[k12]; k = atom->map(kneigh); if (k < 0) error->one(FLERR,"AMOEBA kmpole() could not find bond partner"); ktype = amtype[k]; if (ktype == xtype) { - if (ytype == 0 && !flag) { // only match first time - //if (ytype == 0) { + if (ytype == 0 && !flag) { flag = 1; zaxis[i] = jneigh; xaxis[i] = kneigh; @@ -148,22 +132,15 @@ void PairAmoeba::kmpole() polaxe[i] = mpaxis[itype][iframe]; for (j = 0; j < 13; j++) pole[i][j] = fpole[itype][iframe][j]; - //if (nframe > 1) - //printf("KMPOLEA: id %d itype %d iframe %d nframe %d " - // "xyzaxis %d %d %d\n", - // atom->tag[i],itype,iframe+1,nframe, - // xaxis[i],yaxis[i],zaxis[i]); } else { for (m12 = 0; m12 < nspecial[i][0]; m12++) { if (m12 == j12 || m12 == k12) continue; - //mneigh = special[i][m12]; mneigh = bondneigh[m12]; m = atom->map(mneigh); if (m < 0) error->one(FLERR,"AMOEBA kmpole() could not find bond partner"); mtype = amtype[m]; if (mtype == ytype && !flag) { - //if (mtype == ytype) { flag = 1; zaxis[i] = jneigh; xaxis[i] = kneigh; @@ -171,11 +148,6 @@ void PairAmoeba::kmpole() polaxe[i] = mpaxis[itype][iframe]; for (j = 0; j < 13; j++) pole[i][j] = fpole[itype][iframe][j]; - //if (nframe > 1) - //printf("KMPOLEB: id %d itype %d iframe %d nframe %d " - // "xyzaxis %d %d %d\n", - // atom->tag[i],itype,iframe+1,nframe, - // xaxis[i],yaxis[i],zaxis[i]); } } } @@ -185,9 +157,6 @@ void PairAmoeba::kmpole() } } - //if (atom->tag[i] == 68) printf("FLAG 68 %d: %d %d %d\n", - // flag,xaxis[i],yaxis[i],zaxis[i]); - if (flag) continue; // assign xyz axis via 1-2 and 1-3 connected atoms @@ -197,14 +166,12 @@ void PairAmoeba::kmpole() ytype = ypole[itype][iframe]; ztype = zpole[itype][iframe]; for (j12 = 0; j12 < nspecial[i][0]; j12++) { - //jneigh = special[i][j12]; jneigh = bondneigh[j12]; j = atom->map(jneigh); if (j < 0) error->one(FLERR,"AMOEBA kmpole() could not find bond partner"); jtype = amtype[j]; if (jtype == ztype) { for (k13 = nspecial[i][0]; k13 < nspecial[i][1]; k13++) { - //kneigh = special[i][k13]; kneigh = angleneigh[k13]; k = atom->map(kneigh); if (k < 0) error->one(FLERR,"AMOEBA kmpole() could not find bond partner"); @@ -216,7 +183,6 @@ void PairAmoeba::kmpole() if (ktype == xtype) { if (ytype == 0 && !flag) { - //if (ytype == 0) { flag = 1; zaxis[i] = jneigh; xaxis[i] = kneigh; @@ -224,15 +190,9 @@ void PairAmoeba::kmpole() polaxe[i] = mpaxis[itype][iframe]; for (j = 0; j < 13; j++) pole[i][j] = fpole[itype][iframe][j]; - //if (nframe > 1) - // printf("KMPOLEC: id %d itype %d iframe %d nframe %d " - // "xyzaxis %d %d %d\n", - // atom->tag[i],itype,iframe+1,nframe, - // xaxis[i],yaxis[i],zaxis[i]); } else { for (m13 = nspecial[i][0]; m13 < nspecial[i][1]; m13++) { if (m13 == k13) continue; - //mneigh = special[i][m13]; mneigh = angleneigh[m13]; m = atom->map(mneigh); if (m < 0) @@ -243,7 +203,6 @@ void PairAmoeba::kmpole() if (special[m][m12] == jneigh) path = true; if (!path) continue; if (mtype == ytype && !flag) { - //if (mtype == ytype) { flag = 1; zaxis[i] = jneigh; xaxis[i] = kneigh; @@ -251,11 +210,6 @@ void PairAmoeba::kmpole() polaxe[i] = mpaxis[itype][iframe]; for (j = 0; j < 13; j++) pole[i][j] = fpole[itype][iframe][j]; - //if (nframe > 1) - //printf("KMPOLED: id %d itype %d iframe %d nframe %d " - // "xyzaxis %d %d %d\n", - // atom->tag[i],itype,iframe+1,nframe, - // xaxis[i],yaxis[i],zaxis[i]); } } } @@ -274,25 +228,18 @@ void PairAmoeba::kmpole() ytype = ypole[itype][iframe]; ztype = zpole[itype][iframe]; for (j12 = 0; j12 < nspecial[i][0]; j12++) { - //jneigh = special[i][j12]; jneigh = bondneigh[j12]; j = atom->map(jneigh); if (j < 0) error->one(FLERR,"AMOEBA kmpole() could not find bond partner"); jtype = amtype[j]; if (jtype == ztype) { if (xtype == 0 && !flag) { - //if (xtype == 0) { flag = 1; zaxis[i] = jtype; xaxis[i] = yaxis[i] = 0; polaxe[i] = mpaxis[itype][iframe]; for (j = 0; j < 13; j++) pole[i][j] = fpole[itype][iframe][j]; - //if (nframe > 1) - //printf("KMPOLEE: id %d itype %d iframe %d nframe %d " - // "xyzaxis %d %d %d\n", - // atom->tag[i],itype,iframe+1,nframe, - // xaxis[i],yaxis[i],zaxis[i]); } } } @@ -307,17 +254,11 @@ void PairAmoeba::kmpole() ytype = ypole[itype][iframe]; ztype = zpole[itype][iframe]; if (ztype == 0 && !flag) { - //if (ztype == 0) { flag = 1; zaxis[i] = xaxis[i] = yaxis[i] = 0; polaxe[i] = mpaxis[itype][iframe]; for (j = 0; j < 13; j++) pole[i][j] = fpole[itype][iframe][j]; - //if (nframe > 1) - //printf("KMPOLEF: id %d itype %d iframe %d nframe %d " - // "xyzaxis %d %d %d\n", - // atom->tag[i],itype,iframe+1,nframe, - // xaxis[i],yaxis[i],zaxis[i]); } } @@ -328,19 +269,6 @@ void PairAmoeba::kmpole() nmissing++; } - // DEBUG - - /* - for (i = 0; i < nlocal; i++) - if (atom->tag[i] == 68) - printf("KMPOLE %d %d: %g %g %g %g: %g %g %g %g: %g %g %g %g: %g\n", - i,atom->tag[i], - pole[i][0],pole[i][1],pole[i][2],pole[i][3], - pole[i][4],pole[i][5],pole[i][6],pole[i][7], - pole[i][8],pole[i][9],pole[i][10],pole[i][11], - pole[i][12]); - */ - // error check on missing settings int nmissing_all; @@ -412,18 +340,6 @@ void PairAmoeba::chkpole(int i) pole[i][9] = -pole[i][9]; pole[i][11] = -pole[i][11]; } - - // DEBUG - - /* - if (atom->tag[i] == 68) - printf("CHKPOLE %d %d: %g %g %g %g: %g %g %g %g: %g %g %g %g: %g\n", - i,atom->tag[i], - pole[i][0],pole[i][1],pole[i][2],pole[i][3], - pole[i][4],pole[i][5],pole[i][6],pole[i][7], - pole[i][8],pole[i][9],pole[i][10],pole[i][11], - pole[i][12]); - */ } /* ---------------------------------------------------------------------- @@ -634,17 +550,6 @@ void PairAmoeba::rotmat(int i) rotate[1][0] = rotate[0][2]*rotate[2][1] - rotate[0][1]*rotate[2][2]; rotate[1][1] = rotate[0][0]*rotate[2][2] - rotate[0][2]*rotate[2][0]; rotate[1][2] = rotate[0][1]*rotate[2][0] - rotate[0][0]*rotate[2][1]; - - // DEBUG - - /* - if (atom->tag[i] == 68) - printf("ROTMAT %d %d: %d: %d %d %d: %d %d %d: %g %g %g: %g %g %g: %g %g %g\n", - i,atom->tag[i],polaxe[i],ix,iy,iz,atom->tag[ix],atom->tag[iy],atom->tag[iz], - rotate[0][0],rotate[0][1],rotate[0][2], - rotate[1][0],rotate[1][1],rotate[1][2], - rotate[2][0],rotate[2][1],rotate[2][2]); - */ } /* ---------------------------------------------------------------------- @@ -762,10 +667,6 @@ void PairAmoeba::add_onefive_neighbors() j &= NEIGHMASK; jtag = tag[j]; - //if (atom->tag[i] == 1 && which) - // printf("ONEFIVE tags %d %d ij %d %d which %d jlist %d\n", - // atom->tag[i],atom->tag[j],i,j,which,jlist[jj]); - if (!which) { for (k = 0; k < n15; k++) { if (list15[k] == jtag) { @@ -777,10 +678,6 @@ void PairAmoeba::add_onefive_neighbors() if (which) jlist[jj] = j ^ (which << SBBITS15); int newwhich = sbmask15(jlist[jj]); - - //if (atom->tag[i] == 1 && which) - // printf(" AFTER tags %d %d ij %d %d which %d jlist %d newwhich %d\n", - // atom->tag[i],atom->tag[j],i,j,which,jlist[jj],newwhich); } } } @@ -825,41 +722,49 @@ void PairAmoeba::find_hydrogen_neighbors() void PairAmoeba::find_multipole_neighbors() { - int index; + int index,ypos; // grab current pts for xaxis,yaxis,zaxis // xyz axis[i] = atom IDs that atom I uses for its multipole orientation + // can be zero if not used, in which case set local index to self + // yaxis can be negative, in which case use absolute value xaxis = atom->ivector[index_xaxis]; - yaxis = atom->ivector[index_xaxis]; + yaxis = atom->ivector[index_yaxis]; zaxis = atom->ivector[index_zaxis]; int nlocal = atom->nlocal; int nmissing = 0; - // NOTE: are some of xyz axis not atom IDs, e.g. if has no bonds - for (int i = 0; i < nlocal; i++) { - index = atom->map(xaxis[i]); - if (index == -1) nmissing++; - else { - index = domain->closest_image(i,index); - xaxis2local[i] = index; - } + if (xaxis[i]) { + index = atom->map(xaxis[i]); + if (index == -1) nmissing++; + else { + index = domain->closest_image(i,index); + xaxis2local[i] = index; + } + } else xaxis2local[i] = i; - index = atom->map(yaxis[i]); - if (index == -1) nmissing++; - else { - index = domain->closest_image(i,index); - yaxis2local[i] = index; - } + if (yaxis[i]) { + if (yaxis[i] > 0) ypos = yaxis[i]; + else ypos = -yaxis[i]; + index = atom->map(ypos); + if (index == -1) nmissing++; + else { + index = domain->closest_image(i,index); + yaxis2local[i] = index; + } + } else yaxis2local[i] = i; - index = atom->map(zaxis[i]); - if (index == -1) nmissing++; - else { - index = domain->closest_image(i,index); - zaxis2local[i] = index; - } + if (zaxis[i]) { + index = atom->map(zaxis[i]); + if (index == -1) nmissing++; + else { + index = domain->closest_image(i,index); + zaxis2local[i] = index; + } + } else zaxis2local[i] = i; } // error check on missing neighbors diff --git a/src/AMOEBA/pair_amoeba.h b/src/AMOEBA/pair_amoeba.h index 3925f72683..faaedb34ed 100644 --- a/src/AMOEBA/pair_amoeba.h +++ b/src/AMOEBA/pair_amoeba.h @@ -245,7 +245,6 @@ class PairAmoeba : public Pair { // peratom values computed each step // none of them persist with atoms // some of them need communication to ghosts - // NOTE: allocated to nlocal or nmax? double **rpole; // multipole, comm to ghosts From 73d4d243f4256bd2cf53cbf2fbbeb515944421f4 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Mon, 11 Apr 2022 13:53:47 -0600 Subject: [PATCH 109/585] revert force flip on couple of files --- src/AMOEBA/amoeba_repulsion.cpp | 14 ++++++------- src/AMOEBA/amoeba_utils.cpp | 36 ++++++++++++++++----------------- 2 files changed, 24 insertions(+), 26 deletions(-) diff --git a/src/AMOEBA/amoeba_repulsion.cpp b/src/AMOEBA/amoeba_repulsion.cpp index 2823a82de2..0342eeb513 100644 --- a/src/AMOEBA/amoeba_repulsion.cpp +++ b/src/AMOEBA/amoeba_repulsion.cpp @@ -334,22 +334,20 @@ void PairAmoeba::repulsion() erepulse += e; - //fprintf(fp,"REPUL %d %d %15.12g %15.12g\n",atom->tag[i],atom->tag[j],r,e); - // increment force-based gradient and torque on atom I - f[i][0] += frcx; - f[i][1] += frcy; - f[i][2] += frcz; + f[i][0] -= frcx; + f[i][1] -= frcy; + f[i][2] -= frcz; tq[i][0] += ttri[0]; tq[i][1] += ttri[1]; tq[i][2] += ttri[2]; // increment force-based gradient and torque on atom J - f[j][0] -= frcx; - f[j][1] -= frcy; - f[j][2] -= frcz; + f[j][0] += frcx; + f[j][1] += frcy; + f[j][2] += frcz; tq[j][0] += ttrk[0]; tq[j][1] += ttrk[1]; tq[j][2] += ttrk[2]; diff --git a/src/AMOEBA/amoeba_utils.cpp b/src/AMOEBA/amoeba_utils.cpp index e5831f9348..422b905949 100644 --- a/src/AMOEBA/amoeba_utils.cpp +++ b/src/AMOEBA/amoeba_utils.cpp @@ -1016,8 +1016,8 @@ void PairAmoeba::torque2force(int i, double *trq, if (axetyp == ZONLY) { for (j = 0; j < 3; j++) { du = uv[j]*dphidv/(usiz*uvsin) + uw[j]*dphidw/usiz; - f[ia][j] -= du; - f[ib][j] += du; + f[ia][j] += du; + f[ib][j] -= du; frcz[j] += du; } @@ -1027,9 +1027,9 @@ void PairAmoeba::torque2force(int i, double *trq, for (j = 0; j < 3; j++) { du = uv[j]*dphidv/(usiz*uvsin) + uw[j]*dphidw/usiz; dv = -uv[j]*dphidu/(vsiz*uvsin); - f[ia][j] -= du; - f[ic][j] -= dv; - f[ib][j] += du + dv; + f[ia][j] += du; + f[ic][j] += dv; + f[ib][j] -= du + dv; frcz[j] += du; frcx[j] += dv; } @@ -1040,9 +1040,9 @@ void PairAmoeba::torque2force(int i, double *trq, for (j = 0; j < 3; j++) { du = uv[j]*dphidv/(usiz*uvsin) + 0.5*uw[j]*dphidw/usiz; dv = -uv[j]*dphidu/(vsiz*uvsin) + 0.5*vw[j]*dphidw/vsiz; - f[ia][j] -= du; - f[ic][j] -= dv; - f[ib][j] += du + dv; + f[ia][j] += du; + f[ic][j] += dv; + f[ib][j] -= du + dv; frcz[j] += du; frcx[j] += dv; } @@ -1054,10 +1054,10 @@ void PairAmoeba::torque2force(int i, double *trq, du = ur[j]*dphidr/(usiz*ursin) + us[j]*dphids/usiz; dv = (vssin*s[j]-vscos*t1[j])*dphidu / (vsiz*(ut1sin+ut2sin)); dw = (wssin*s[j]-wscos*t2[j])*dphidu / (wsiz*(ut1sin+ut2sin)); - f[ia][j] -= du; - f[ic][j] -= dv; - f[id][j] -= dw; - f[ib][j] += du + dv + dw; + f[ia][j] += du; + f[ic][j] += dv; + f[id][j] += dw; + f[ib][j] -= du + dv + dw; frcz[j] += du; frcx[j] += dv; frcy[j] += dw; @@ -1096,8 +1096,8 @@ void PairAmoeba::torque2force(int i, double *trq, eps[2] = del[0]*w[1] - del[1]*w[0]; for (j = 0; j < 3; j++) { dw = del[j]*dphidr/(wsiz*rwsin) + eps[j]*dphiddel*wpcos/(wsiz*psiz); - f[id][j] -= dw; - f[ib][j] += dw; + f[id][j] += dw; + f[ib][j] -= dw; frcy[j] += dw; } r[0] = v[0] + w[0]; @@ -1121,8 +1121,8 @@ void PairAmoeba::torque2force(int i, double *trq, eps[2] = del[0]*u[1] - del[1]*u[0]; for (j = 0; j < 3; j++) { du = del[j]*dphidr/(usiz*rusin) + eps[j]*dphiddel*upcos/(usiz*psiz); - f[ia][j] -= du; - f[ib][j] += du; + f[ia][j] += du; + f[ib][j] -= du; frcz[j] += du; } r[0] = u[0] + w[0]; @@ -1146,8 +1146,8 @@ void PairAmoeba::torque2force(int i, double *trq, eps[2] = del[0]*v[1] - del[1]*v[0]; for (j = 0; j < 3; j++) { dv = del[j]*dphidr/(vsiz*rvsin) + eps[j]*dphiddel*vpcos/(vsiz*psiz); - f[ic][j] -= dv; - f[ib][j] += dv; + f[ic][j] += dv; + f[ib][j] -= dv; frcx[j] += dv; } } From 429163d2b29608892c67d69852802e062de3dc0f Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Mon, 11 Apr 2022 14:47:14 -0600 Subject: [PATCH 110/585] Added check for grid points outside subdomain --- src/compute_grid_local.cpp | 8 ++++++++ 1 file changed, 8 insertions(+) diff --git a/src/compute_grid_local.cpp b/src/compute_grid_local.cpp index e99a742c3b..d751a517cb 100644 --- a/src/compute_grid_local.cpp +++ b/src/compute_grid_local.cpp @@ -238,6 +238,14 @@ void ComputeGridLocal::assign_coords() alocal[igrid][2] = iz; double xgrid[3]; grid2x(ix, iy, iz, xgrid); + + // ensure gridpoint is not strictly outside subdomain + + if (xgrid[0] < sublo[0] && xgrid[0] > subhi[0] && + xgrid[1] < sublo[1] && xgrid[1] > subhi[1] && + xgrid[2] < sublo[2] && xgrid[2] > subhi[2]) + error->all(FLERR,"Invalid gridpoint position in compute grid/local"); + alocal[igrid][3] = xgrid[0]; alocal[igrid][4] = xgrid[1]; alocal[igrid][5] = xgrid[2]; From bae9ef7e565e2616cef8901fc0dc923f210f4754 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Mon, 11 Apr 2022 14:51:15 -0600 Subject: [PATCH 111/585] Added check for grid points outside subdomain --- src/compute_grid_local.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/compute_grid_local.cpp b/src/compute_grid_local.cpp index d751a517cb..33e2bc9c49 100644 --- a/src/compute_grid_local.cpp +++ b/src/compute_grid_local.cpp @@ -244,7 +244,7 @@ void ComputeGridLocal::assign_coords() if (xgrid[0] < sublo[0] && xgrid[0] > subhi[0] && xgrid[1] < sublo[1] && xgrid[1] > subhi[1] && xgrid[2] < sublo[2] && xgrid[2] > subhi[2]) - error->all(FLERR,"Invalid gridpoint position in compute grid/local"); + error->one(FLERR,"Invalid gridpoint position in compute grid/local"); alocal[igrid][3] = xgrid[0]; alocal[igrid][4] = xgrid[1]; From c939316b99b9e06ac10d14455665ee85b4712ff4 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Mon, 11 Apr 2022 14:52:35 -0600 Subject: [PATCH 112/585] Added check for grid points outside subdomain --- src/compute_grid_local.cpp | 6 +++--- 1 file changed, 3 insertions(+), 3 deletions(-) diff --git a/src/compute_grid_local.cpp b/src/compute_grid_local.cpp index 33e2bc9c49..299e42d81d 100644 --- a/src/compute_grid_local.cpp +++ b/src/compute_grid_local.cpp @@ -241,9 +241,9 @@ void ComputeGridLocal::assign_coords() // ensure gridpoint is not strictly outside subdomain - if (xgrid[0] < sublo[0] && xgrid[0] > subhi[0] && - xgrid[1] < sublo[1] && xgrid[1] > subhi[1] && - xgrid[2] < sublo[2] && xgrid[2] > subhi[2]) + if (xgrid[0] < sublo[0] || xgrid[0] > subhi[0] || + xgrid[1] < sublo[1] || xgrid[1] > subhi[1] || + xgrid[2] < sublo[2] || xgrid[2] > subhi[2]) error->one(FLERR,"Invalid gridpoint position in compute grid/local"); alocal[igrid][3] = xgrid[0]; From d9b34d50183fb4e94fec34c164afc0a3173c6657 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Mon, 11 Apr 2022 17:03:49 -0600 Subject: [PATCH 113/585] more sign flipping --- examples/amoeba/in.water_dimer.amoeba | 2 +- examples/amoeba/in.water_dimer.hippo | 2 +- src/AMOEBA/amoeba_utils.cpp | 49 ++++++++++----------------- 3 files changed, 20 insertions(+), 33 deletions(-) diff --git a/examples/amoeba/in.water_dimer.amoeba b/examples/amoeba/in.water_dimer.amoeba index 8c4a317643..05c2ff0584 100644 --- a/examples/amoeba/in.water_dimer.amoeba +++ b/examples/amoeba/in.water_dimer.amoeba @@ -21,7 +21,7 @@ read_data data.water_dimer.amoeba fix amtype NULL "Tinker Types" # force field -pair_style amoeba include angle +pair_style amoeba pair_coeff * * amoeba_water.prm amoeba_water.key special_bonds lj/coul 0.5 0.5 0.5 one/five yes diff --git a/examples/amoeba/in.water_dimer.hippo b/examples/amoeba/in.water_dimer.hippo index 7401c21310..4ebe6d33ab 100644 --- a/examples/amoeba/in.water_dimer.hippo +++ b/examples/amoeba/in.water_dimer.hippo @@ -21,7 +21,7 @@ read_data data.water_dimer.hippo fix amtype NULL "Tinker Types" # force field -pair_style hippo include angle +pair_style hippo pair_coeff * * hippo_water.prm hippo_water.key special_bonds lj/coul 0.5 0.5 0.5 one/five yes diff --git a/src/AMOEBA/amoeba_utils.cpp b/src/AMOEBA/amoeba_utils.cpp index 422b905949..42a9fb7f1f 100644 --- a/src/AMOEBA/amoeba_utils.cpp +++ b/src/AMOEBA/amoeba_utils.cpp @@ -607,19 +607,6 @@ void PairAmoeba::rotsite(int isite) k++; } } - - // DEBUG - - /* - i = isite; - if (atom->tag[i] == 68) - printf("ROTSITE %d %d: %g %g %g %g: %g %g %g %g: %g %g %g %g: %g\n", - i,atom->tag[i], - rpole[i][0],rpole[i][1],rpole[i][2],rpole[i][3], - rpole[i][4],rpole[i][5],rpole[i][6],rpole[i][7], - rpole[i][8],rpole[i][9],rpole[i][10],rpole[i][11], - rpole[i][12]); - */ } /* ---------------------------------------------------------------------- @@ -1016,8 +1003,8 @@ void PairAmoeba::torque2force(int i, double *trq, if (axetyp == ZONLY) { for (j = 0; j < 3; j++) { du = uv[j]*dphidv/(usiz*uvsin) + uw[j]*dphidw/usiz; - f[ia][j] += du; - f[ib][j] -= du; + f[ia][j] -= du; + f[ib][j] += du; frcz[j] += du; } @@ -1027,9 +1014,9 @@ void PairAmoeba::torque2force(int i, double *trq, for (j = 0; j < 3; j++) { du = uv[j]*dphidv/(usiz*uvsin) + uw[j]*dphidw/usiz; dv = -uv[j]*dphidu/(vsiz*uvsin); - f[ia][j] += du; - f[ic][j] += dv; - f[ib][j] -= du + dv; + f[ia][j] -= du; + f[ic][j] -= dv; + f[ib][j] += du + dv; frcz[j] += du; frcx[j] += dv; } @@ -1040,9 +1027,9 @@ void PairAmoeba::torque2force(int i, double *trq, for (j = 0; j < 3; j++) { du = uv[j]*dphidv/(usiz*uvsin) + 0.5*uw[j]*dphidw/usiz; dv = -uv[j]*dphidu/(vsiz*uvsin) + 0.5*vw[j]*dphidw/vsiz; - f[ia][j] += du; - f[ic][j] += dv; - f[ib][j] -= du + dv; + f[ia][j] -= du; + f[ic][j] -= dv; + f[ib][j] += du + dv; frcz[j] += du; frcx[j] += dv; } @@ -1054,10 +1041,10 @@ void PairAmoeba::torque2force(int i, double *trq, du = ur[j]*dphidr/(usiz*ursin) + us[j]*dphids/usiz; dv = (vssin*s[j]-vscos*t1[j])*dphidu / (vsiz*(ut1sin+ut2sin)); dw = (wssin*s[j]-wscos*t2[j])*dphidu / (wsiz*(ut1sin+ut2sin)); - f[ia][j] += du; - f[ic][j] += dv; - f[id][j] += dw; - f[ib][j] -= du + dv + dw; + f[ia][j] -= du; + f[ic][j] -= dv; + f[id][j] -= dw; + f[ib][j] += du + dv + dw; frcz[j] += du; frcx[j] += dv; frcy[j] += dw; @@ -1096,8 +1083,8 @@ void PairAmoeba::torque2force(int i, double *trq, eps[2] = del[0]*w[1] - del[1]*w[0]; for (j = 0; j < 3; j++) { dw = del[j]*dphidr/(wsiz*rwsin) + eps[j]*dphiddel*wpcos/(wsiz*psiz); - f[id][j] += dw; - f[ib][j] -= dw; + f[id][j] -= dw; + f[ib][j] += dw; frcy[j] += dw; } r[0] = v[0] + w[0]; @@ -1121,8 +1108,8 @@ void PairAmoeba::torque2force(int i, double *trq, eps[2] = del[0]*u[1] - del[1]*u[0]; for (j = 0; j < 3; j++) { du = del[j]*dphidr/(usiz*rusin) + eps[j]*dphiddel*upcos/(usiz*psiz); - f[ia][j] += du; - f[ib][j] -= du; + f[ia][j] -= du; + f[ib][j] += du; frcz[j] += du; } r[0] = u[0] + w[0]; @@ -1146,8 +1133,8 @@ void PairAmoeba::torque2force(int i, double *trq, eps[2] = del[0]*v[1] - del[1]*v[0]; for (j = 0; j < 3; j++) { dv = del[j]*dphidr/(vsiz*rvsin) + eps[j]*dphiddel*vpcos/(vsiz*psiz); - f[ic][j] += dv; - f[ib][j] -= dv; + f[ic][j] -= dv; + f[ib][j] += dv; frcx[j] += dv; } } From 8aa4c5a0e298d866c1d182cd9dbc3cb66cf07249 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Tue, 12 Apr 2022 12:53:51 -0600 Subject: [PATCH 114/585] debugging on angle term forces --- src/AMOEBA/angle_amoeba.cpp | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/src/AMOEBA/angle_amoeba.cpp b/src/AMOEBA/angle_amoeba.cpp index 6b5bb93c02..f876d7bbb1 100644 --- a/src/AMOEBA/angle_amoeba.cpp +++ b/src/AMOEBA/angle_amoeba.cpp @@ -123,8 +123,8 @@ void AngleAmoeba::compute(int eflag, int vflag) // bondangle = bond-stretch cross term in Tinker - if (ba_k1[type] != 0.0) - tinker_bondangle(i1,i2,i3,type,eflag); + //if (ba_k1[type] != 0.0) + //tinker_bondangle(i1,i2,i3,type,eflag); } // Urey-Bradley H-H bond term within water molecules From 01864189c76bd7e6e1b2f305026ff0cc65d22023 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Tue, 12 Apr 2022 12:54:23 -0600 Subject: [PATCH 115/585] dynamics testing --- examples/amoeba/in.ubiquitin | 5 +++-- examples/amoeba/in.water_box.amoeba | 8 ++++---- examples/amoeba/in.water_box.hippo | 8 ++++---- examples/amoeba/in.water_dimer.amoeba | 8 ++++---- examples/amoeba/in.water_dimer.hippo | 8 ++++---- 5 files changed, 19 insertions(+), 18 deletions(-) diff --git a/examples/amoeba/in.ubiquitin b/examples/amoeba/in.ubiquitin index d5fc3b0079..8870fcdf63 100644 --- a/examples/amoeba/in.ubiquitin +++ b/examples/amoeba/in.ubiquitin @@ -29,7 +29,7 @@ read_data data.ubiquitin fix amtype NULL "Tinker Types" & fix pit pitorsions PiTorsions & fix bit bitorsions BiTorsions -pair_style amoeba +pair_style amoeba include angle pair_coeff * * amoeba_ubiquitin.prm amoeba_ubiquitin.key special_bonds lj/coul 0.5 0.5 0.5 one/five yes @@ -39,10 +39,11 @@ special_bonds lj/coul 0.5 0.5 0.5 one/five yes compute virial all pressure NULL virial thermo_style custom step temp epair ebond eangle edihed eimp & - emol etotal #press c_virial[*] + emol etotal press c_virial[*] # zero step run +dump 1 all custom 10 dump.ubi id type x y z fx fy fz run 0 # dynamics diff --git a/examples/amoeba/in.water_box.amoeba b/examples/amoeba/in.water_box.amoeba index c15a684d95..3a37784f9d 100644 --- a/examples/amoeba/in.water_box.amoeba +++ b/examples/amoeba/in.water_box.amoeba @@ -35,10 +35,10 @@ thermo_style custom step temp epair ebond eangle edihed eimp & # zero step run -run 0 +#run 0 # dynamics -#thermo 1 -#fix 1 all nve -#run 100 +thermo 1 +fix 1 all nve +run 100 diff --git a/examples/amoeba/in.water_box.hippo b/examples/amoeba/in.water_box.hippo index df2f961b56..8e1d9a8e70 100644 --- a/examples/amoeba/in.water_box.hippo +++ b/examples/amoeba/in.water_box.hippo @@ -35,10 +35,10 @@ thermo_style custom step temp epair ebond eangle edihed eimp & # zero step run -run 0 +#run 0 # dynamics -#thermo 1 -#fix 1 all nve -#run 100 +thermo 1 +fix 1 all nve +run 100 diff --git a/examples/amoeba/in.water_dimer.amoeba b/examples/amoeba/in.water_dimer.amoeba index 05c2ff0584..c0e6ee35e4 100644 --- a/examples/amoeba/in.water_dimer.amoeba +++ b/examples/amoeba/in.water_dimer.amoeba @@ -35,10 +35,10 @@ thermo_style custom step temp epair ebond eangle edihed eimp & # zero step run -run 0 +#run 0 # dynamics -#thermo 1 -#fix 1 all nve -#run 100 +thermo 1 +fix 1 all nve +run 100 diff --git a/examples/amoeba/in.water_dimer.hippo b/examples/amoeba/in.water_dimer.hippo index 4ebe6d33ab..55b173b789 100644 --- a/examples/amoeba/in.water_dimer.hippo +++ b/examples/amoeba/in.water_dimer.hippo @@ -35,10 +35,10 @@ thermo_style custom step temp epair ebond eangle edihed eimp & # zero step run -run 0 +#run 0 # dynamics -#thermo 1 -#fix 1 all nve -#run 100 +thermo 1 +fix 1 all nve +run 100 From abb9880dc6715a21e74199aca01ac038b8c0e56e Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Wed, 13 Apr 2022 12:31:23 -0600 Subject: [PATCH 116/585] degugging on angle term --- src/AMOEBA/angle_amoeba.cpp | 16 ++++++++++------ 1 file changed, 10 insertions(+), 6 deletions(-) diff --git a/src/AMOEBA/angle_amoeba.cpp b/src/AMOEBA/angle_amoeba.cpp index f876d7bbb1..6ada36ea2a 100644 --- a/src/AMOEBA/angle_amoeba.cpp +++ b/src/AMOEBA/angle_amoeba.cpp @@ -116,15 +116,15 @@ void AngleAmoeba::compute(int eflag, int vflag) if (enable_angle) { tflag = pflag[type]; - if (tflag && nspecial[i2][0] == 3) - tinker_anglep(i1,i2,i3,type,eflag); - else - tinker_angle(i1,i2,i3,type,eflag); + //if (tflag && nspecial[i2][0] == 3) + // tinker_anglep(i1,i2,i3,type,eflag); + //else + // tinker_angle(i1,i2,i3,type,eflag); // bondangle = bond-stretch cross term in Tinker - //if (ba_k1[type] != 0.0) - //tinker_bondangle(i1,i2,i3,type,eflag); + if (ba_k1[type] != 0.0) + tinker_bondangle(i1,i2,i3,type,eflag); } // Urey-Bradley H-H bond term within water molecules @@ -511,6 +511,10 @@ void AngleAmoeba::tinker_bondangle(int i1, int i2, int i3, int type, int eflag) eangle = 0.0; if (eflag) eangle = ba_k1[type]*dr1*dtheta + ba_k2[type]*dr2*dtheta; + printf("BA: ijk %d %d %d eng %g fi %g %g %g fk %g %g %g\n", + atom->tag[i1],atom->tag[i2],atom->tag[i3], + eangle,f1[0],f1[1],f1[2],f3[0],f3[1],f3[2]); + // apply force to each of 3 atoms if (newton_bond || i1 < nlocal) { From 578a9ab1611ff700ce59ef38b142c92fdfac8a7d Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Wed, 13 Apr 2022 14:52:01 -0600 Subject: [PATCH 117/585] bug fix for bondangle term --- src/AMOEBA/angle_amoeba.cpp | 16 ++++++---------- 1 file changed, 6 insertions(+), 10 deletions(-) diff --git a/src/AMOEBA/angle_amoeba.cpp b/src/AMOEBA/angle_amoeba.cpp index 6ada36ea2a..6f4f72b432 100644 --- a/src/AMOEBA/angle_amoeba.cpp +++ b/src/AMOEBA/angle_amoeba.cpp @@ -500,21 +500,17 @@ void AngleAmoeba::tinker_bondangle(int i1, int i2, int i3, int type, int eflag) b1 = ba_k1[type] * dtheta / r1; b2 = ba_k2[type] * dtheta / r2; - f1[0] -= vx11 + b1*delx1 + vx12; - f1[1] -= vy11 + b1*dely1 + vy12; - f1[2] -= vz11 + b1*delz1 + vz12; + f1[0] = -(vx11 + b1*delx1 + vx12); + f1[1] = -(vy11 + b1*dely1 + vy12); + f1[2] = -(vz11 + b1*delz1 + vz12); - f3[0] -= vx21 + b2*delx2 + vx22; - f3[1] -= vy21 + b2*dely2 + vy22; - f3[2] -= vz21 + b2*delz2 + vz22; + f3[0] = -(vx21 + b2*delx2 + vx22); + f3[1] = -(vy21 + b2*dely2 + vy22); + f3[2] = -(vz21 + b2*delz2 + vz22); eangle = 0.0; if (eflag) eangle = ba_k1[type]*dr1*dtheta + ba_k2[type]*dr2*dtheta; - printf("BA: ijk %d %d %d eng %g fi %g %g %g fk %g %g %g\n", - atom->tag[i1],atom->tag[i2],atom->tag[i3], - eangle,f1[0],f1[1],f1[2],f3[0],f3[1],f3[2]); - // apply force to each of 3 atoms if (newton_bond || i1 < nlocal) { From 2c7badfa43f3b83485be9bd47e84f1234744ba72 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Wed, 13 Apr 2022 17:05:44 -0600 Subject: [PATCH 118/585] debug for improper amoeba --- examples/amoeba/in.ubiquitin | 2 +- src/AMOEBA/angle_amoeba.cpp | 12 ++++++------ src/AMOEBA/improper_amoeba.cpp | 8 +++++++- 3 files changed, 14 insertions(+), 8 deletions(-) diff --git a/examples/amoeba/in.ubiquitin b/examples/amoeba/in.ubiquitin index 8870fcdf63..8abcac750f 100644 --- a/examples/amoeba/in.ubiquitin +++ b/examples/amoeba/in.ubiquitin @@ -29,7 +29,7 @@ read_data data.ubiquitin fix amtype NULL "Tinker Types" & fix pit pitorsions PiTorsions & fix bit bitorsions BiTorsions -pair_style amoeba include angle +pair_style amoeba include improper pair_coeff * * amoeba_ubiquitin.prm amoeba_ubiquitin.key special_bonds lj/coul 0.5 0.5 0.5 one/five yes diff --git a/src/AMOEBA/angle_amoeba.cpp b/src/AMOEBA/angle_amoeba.cpp index 6f4f72b432..fb59ecb39d 100644 --- a/src/AMOEBA/angle_amoeba.cpp +++ b/src/AMOEBA/angle_amoeba.cpp @@ -116,17 +116,17 @@ void AngleAmoeba::compute(int eflag, int vflag) if (enable_angle) { tflag = pflag[type]; - //if (tflag && nspecial[i2][0] == 3) - // tinker_anglep(i1,i2,i3,type,eflag); - //else - // tinker_angle(i1,i2,i3,type,eflag); + if (tflag && nspecial[i2][0] == 3) + tinker_anglep(i1,i2,i3,type,eflag); + else + tinker_angle(i1,i2,i3,type,eflag); // bondangle = bond-stretch cross term in Tinker - + if (ba_k1[type] != 0.0) tinker_bondangle(i1,i2,i3,type,eflag); } - + // Urey-Bradley H-H bond term within water molecules if (enable_urey) { diff --git a/src/AMOEBA/improper_amoeba.cpp b/src/AMOEBA/improper_amoeba.cpp index d821c9411a..64c2f77030 100644 --- a/src/AMOEBA/improper_amoeba.cpp +++ b/src/AMOEBA/improper_amoeba.cpp @@ -197,7 +197,13 @@ void ImproperAmoeba::compute(int eflag, int vflag) fd[2] = dedcos * (dccdzid+deedzid); fb[0] = -fa[0] - fc[0] - fd[0]; fb[1] = -fa[1] - fc[1] - fd[1]; - fb[2] = -fa[1] - fc[2] - fd[2]; + fb[2] = -fa[2] - fc[2] - fd[2]; + + printf("IMP DBAC %d %d %d %d: angle %g eng %g dedcos %g " + "fD %g %g %g fA %g %g %g fC %g %g %g\n", + atom->tag[id],atom->tag[ib],atom->tag[ia],atom->tag[ic], + angle,e,dedcos,fd[0],fd[1],fd[2],fa[0],fa[1],fa[2], + fc[0],fc[1],fc[2]); // apply force to each of 4 atoms From fccca3405a973901fd363fa877c97524750ef6a2 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Thu, 14 Apr 2022 13:20:14 -0600 Subject: [PATCH 119/585] fixed bug in improper amoeba --- src/AMOEBA/improper_amoeba.cpp | 12 ++++++++---- 1 file changed, 8 insertions(+), 4 deletions(-) diff --git a/src/AMOEBA/improper_amoeba.cpp b/src/AMOEBA/improper_amoeba.cpp index 64c2f77030..73062505f3 100644 --- a/src/AMOEBA/improper_amoeba.cpp +++ b/src/AMOEBA/improper_amoeba.cpp @@ -79,7 +79,8 @@ void ImproperAmoeba::compute(int eflag, int vflag) // conversion factors for radians to degrees and vice versa double rad2degree = 180.0/MY_PI; - double prefactor = 1.0 / (rad2degree*rad2degree); + double eprefactor = 1.0 / (rad2degree*rad2degree); + double fprefactor = 1.0 / rad2degree; for (n = 0; n < nimproperlist; n++) { @@ -151,10 +152,11 @@ void ImproperAmoeba::compute(int eflag, int vflag) dt2 = dt * dt; dt3 = dt2 * dt; dt4 = dt2 * dt2; - e = prefactor * k[type] * dt2 * (1.0 + opbend_cubic*dt + opbend_quartic*dt2 + - opbend_pentic*dt3 + opbend_sextic*dt4); + e = eprefactor * k[type] * dt2 * + (1.0 + opbend_cubic*dt + opbend_quartic*dt2 + + opbend_pentic*dt3 + opbend_sextic*dt4); - deddt = k[type] * dt * + deddt = fprefactor * k[type] * dt * (2.0 + 3.0*opbend_cubic*dt + 4.0*opbend_quartic*dt2 + 5.0*opbend_pentic*dt3 + 6.0*opbend_sextic*dt4); sign = (ee >= 0.0) ? 1.0 : -1.0; @@ -199,11 +201,13 @@ void ImproperAmoeba::compute(int eflag, int vflag) fb[1] = -fa[1] - fc[1] - fd[1]; fb[2] = -fa[2] - fc[2] - fd[2]; + /* printf("IMP DBAC %d %d %d %d: angle %g eng %g dedcos %g " "fD %g %g %g fA %g %g %g fC %g %g %g\n", atom->tag[id],atom->tag[ib],atom->tag[ia],atom->tag[ic], angle,e,dedcos,fd[0],fd[1],fd[2],fa[0],fa[1],fa[2], fc[0],fc[1],fc[2]); + */ // apply force to each of 4 atoms From 8932d9ffaa2d1af65122244f3cee24a84857ad2b Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Mon, 18 Apr 2022 16:38:41 -0600 Subject: [PATCH 120/585] doc pages for AMOEBA/HIPPO --- doc/src/Commands_bond.rst | 2 + doc/src/Commands_fix.rst | 2 + doc/src/Commands_pair.rst | 2 + doc/src/Howto_amoeba.rst | 307 +++++++++++++++++++++++-------- doc/src/angle_amoeba.rst | 137 ++++++++++++++ doc/src/angle_class2.rst | 2 +- doc/src/angle_style.rst | 1 + doc/src/atom_style.rst | 51 +++-- doc/src/fix.rst | 4 +- doc/src/fix_amoeba_bitorsion.rst | 167 +++++++++++++++++ doc/src/fix_amoeba_pitorsion.rst | 186 +++++++++++++++++++ doc/src/fix_cmap.rst | 66 +++---- doc/src/improper_amoeba.rst | 77 ++++++++ doc/src/improper_style.rst | 1 + doc/src/pair_amoeba.rst | 163 ++++++++-------- doc/src/special_bonds.rst | 104 ++++++----- src/AMOEBA/amoeba_file.cpp | 3 - src/AMOEBA/pair_amoeba.cpp | 8 - 18 files changed, 1015 insertions(+), 268 deletions(-) create mode 100644 doc/src/angle_amoeba.rst create mode 100644 doc/src/fix_amoeba_bitorsion.rst create mode 100644 doc/src/fix_amoeba_pitorsion.rst create mode 100644 doc/src/improper_amoeba.rst diff --git a/doc/src/Commands_bond.rst b/doc/src/Commands_bond.rst index 1a0876e88f..0f6cac6a5b 100644 --- a/doc/src/Commands_bond.rst +++ b/doc/src/Commands_bond.rst @@ -71,6 +71,7 @@ OPT. * * * + * :doc:`amoeba ` * :doc:`charmm (iko) ` * :doc:`class2 (ko) ` * :doc:`class2/p6 ` @@ -149,6 +150,7 @@ OPT. * * * + * :doc:`amoeba ` * :doc:`class2 (ko) ` * :doc:`cossq (o) ` * :doc:`cvff (io) ` diff --git a/doc/src/Commands_fix.rst b/doc/src/Commands_fix.rst index 45a75ff394..01beef5ea6 100644 --- a/doc/src/Commands_fix.rst +++ b/doc/src/Commands_fix.rst @@ -27,6 +27,8 @@ OPT. * :doc:`adapt/fep ` * :doc:`addforce ` * :doc:`addtorque ` + * :doc:`amoeba/bitorsion ` + * :doc:`amoeba/pitorsion ` * :doc:`append/atoms ` * :doc:`atc ` * :doc:`atom/swap ` diff --git a/doc/src/Commands_pair.rst b/doc/src/Commands_pair.rst index 7cf4e7635b..3765937e1a 100644 --- a/doc/src/Commands_pair.rst +++ b/doc/src/Commands_pair.rst @@ -38,6 +38,7 @@ OPT. * :doc:`agni (o) ` * :doc:`airebo (io) ` * :doc:`airebo/morse (io) ` + * :doc:`amoeba ` * :doc:`atm ` * :doc:`awpmd/cut ` * :doc:`beck (go) ` @@ -122,6 +123,7 @@ OPT. * :doc:`hbond/dreiding/lj (o) ` * :doc:`hbond/dreiding/morse (o) ` * :doc:`hdnnp ` + * :doc:`hippo ` * :doc:`ilp/graphene/hbn ` * :doc:`kolmogorov/crespi/full ` * :doc:`kolmogorov/crespi/z ` diff --git a/doc/src/Howto_amoeba.rst b/doc/src/Howto_amoeba.rst index 9460d54200..6615e319a6 100644 --- a/doc/src/Howto_amoeba.rst +++ b/doc/src/Howto_amoeba.rst @@ -2,36 +2,87 @@ AMOEBA and HIPPO force fields ============================= The AMOEBA and HIPPO polarizable force fields were developed by Jay -Ponder's group at U Washington at St Louis. Their implementation in -LAMMPS was done using F90 code provided by the Ponder group from their -`Tinker MD code `_ +Ponder's group at the U Washington at St Louis. Their implementation +in LAMMPS was done using F90 code provided by the Ponder group from +their `Tinker MD code `_. -NOTE: what version of AMOEBA and HIPPO does LAMMPS implement? +NOTE: What version of AMOEBA and HIPPO does LAMMPS implement? These force fields can be used when polarization effects are desired in simulations of water, organic molecules, and biomolecules including -proteins, provided that parameterizations (force field files) are -available for the systems you are interested in. Files in the LAMMPS -potentials directory with a "amoeba" or "hippo" suffix can be used. -The Tinker distribution and website may have other force field files. +proteins, provided that parameterizations (Tinker PRM force field +files) are available for the systems you are interested in. Files in +the LAMMPS potentials directory with a "amoeba" or "hippo" suffix can +be used. The Tinker distribution and website have additional force +field files as well. + +NOTE: Can we include a few Tinker FF files in the LAMMPS distro, +e.g. ubiquitin.prm as potentials/ubiquitin.prm.amoeba ? Note that currently, HIPPO can only be used for water systems, but HIPPO files for a variety of small organic and biomolecules are in preparation by the Ponder group. Those force field files will be included in the LAMMPS distribution when available. -The :doc:`pair_style amoeba ` doc page gives a brief -description of the AMOEBA and HIPPO force fields. Further details for -AMOEBA are in these papers: :ref:`(Ren) `, :ref:`(Shi) -`. Further details for HIPPO are in this paper: -:ref:`(Rackers) `. +---------- + +The AMOEBA and HIPPO force fields contain the following terms in their +energy (U) computation. Further details for AMOEBA are in these +papers: :ref:`(Ren) `, :ref:`(Shi) `. Further +details for HIPPO are in this paper: :ref:`(Rackers) +`. + +.. math:: + + U & = U_{intermolecular} + U_{intramolecular) \\ + U_{intermolecular} & = U_{hal} + U_{repulsion} + U_{dispersion} + U_{multipole} + U_{polar} + U_{qxfer} \\ + U_{intramolecular} & = U_{bond} + U_{angle} + U_{torsion} + U_{oop} + U_{b\theta} + U_{Urey-Bradley} + U_{pitorsion} + U_{bitorsion} + +For intermolecular terms, the AMOEBA force field includes only the +:math:`U_{hal}`, :math:`U_{multipole}`, :math:`U_{polar}` terms. The +HIPPO force field includes all but the :math:`U_{hal}` term. In +LAMMPS, these are all computed by the :doc:`pair_style ` +command. + +For intramolecular terms, the :math:`U_{bond}`, :math:`U_{angle}`, +:math:`U_{torsion}`, :math:`U_{oop}` terms are computed by the +:doc:`bond_style class2 ` :doc:`angle_style amoeba +`, :doc:`dihedral_style fourier `, and +:doc:`improper_style amoeba ` commands respectively. +The :doc:`angle_style amoeba ` command includes the +:math:`U_{b\theta}` bond-angle cross term, and the +:math:`U_{Urey-Bradley}` term for a bond contribution between the 1-3 +atoms in the angle. + +The :math:`U_{pitorsion}` term is computed by the :doc:`fix +amoeba/pitorsion ` command. It computes 6-body +interaction between a pair of bonded atoms which each have 2 +additional bond partners. + +The :math:`U_{bitorsion}` term is computed by the :doc:`fix +amoeba/bitorsion ` command. It computes 5-body +interaction between two 4-body torsions (dihedrals) which overlap, +having 3 atoms in common. + +These command doc pages have additional details on the terms they +compute: + +* :doc:`pair_style amoeba or hippo ` +* :doc:`bond_style class2 ` +* :doc:`angle_style amoeba ` +* :doc:`dihedral_style fourier ` +* :doc:`improper_style amoeba ` +* :doc:`fix amoeba/pitorsion ` +* :doc:`fix amoeba/bitorsion ` ---------- -To use the AMOEBA force field in LAMMPS you should use command like -these appropriately in your input script. The only change needed for -a HIPPO simulation is for the pair_style and pair_coeff commands. See -examples/amoeba for example input scripts for both AMOEBA and HIPPO. +To use the AMOEBA or HIPPO force fields in LAMMPS, use commands like +the following appropriately in your input script. The only change +needed for AMOEBA vs HIPPO simulation is for the :doc:`pair_style +` and :doc:`pair_coeff ` commands, as shown +below. See examples/amoeba for example input scripts for both AMOEBA +and HIPPO. .. code-block:: LAMMPS @@ -66,73 +117,183 @@ examples/amoeba for example input scripts for both AMOEBA and HIPPO. special_bonds lj/coul 0.5 0.5 0.5 one/five yes # 1-5 neighbors +The data file read by the :doc:`read_data ` command should +be created by the tools/tinker/tinker2lmp.py conversion program +described below. It will create a section in the data file with the +header "Tinker Types". A :doc:`fix property/atom ` +command for the data must be specified befroe the read_data command. +In the example above the fix ID is amtype. -NOTE: that some options not needed for simpler systems +Similarly, if the system you are simulating defines AMOEBA/HIPPO +pitorsion or bitorsion interactions, there will be entries in the data +file for those interactions. They require a :doc:`fix +amoeba/pitortion ` and :doc:`fix +amoeba/bitorsion ` command be defined. In the +example above, the IDs for these two fixes are "pit" and "bit". -NOTE: tinker2lmp.py tool +Of course, if the system being modeled does not have one or more of +the following -- bond, angle, dihedral, improper, pitorision, +bitorsion interactions -- then the corresponding style and fix +commands above do not need to be used. See the example scripts in +examples/amoeba for water systems as examples; they are simpler than +what is listed above. -NOTE: are some commands not needed if system is simple and not ubi2 ? +The two :doc:`fix property/atom ` commands with IDs +"extra" and "polaxe" are also needed to define internal per-atom +quantities used by the AMOEBA and HIPPO force fields. -Both AMOEBA and HIPPO use amoeba for bond/angle/dihedral styles, -assuming the molecular system has bonds, angles, or dihedrals. These -style commands must be be used before the data file is read, as the -data file defines the coefficients for the various bond/angle/dihedral -types. The pair_style command can come after the read_data command, -as no pair coefficients are defined in the data file. +The :doc:`pair_coeff ` command used for either the AMOEBA +or HIPPO force field takes two arguments for Tinker force field files, +namely a PRM and KEY file. The keyfile can be specified as NULL and +default values for a various settings will be used. Note that these 2 +files are meant to allow use of native Tinker files as-is. However +LAMMPS does not support all the options which can be included +in a Tinker PRM or KEY file. See specifis below. -The :doc:`fix property/atom ` commands are required -to create per-atom data used by the AMOEBA/HIPPO force fields, some of -which is defined in the LAMMPS data file. The LAMMPS data file should -be produced as a pre-processing step by the tinker2lmp.py Python -script in tools/amoeba with a command like one of the following. -The tools/amoeba/README file has more details on using this tool. +A :doc:`special_bonds ` command with the "one/five" +option is required, since the AMOEBA/HIPPO force fields define +weighting factors for not only 1-2, 1-3, 1-4 interactions, but also +1-5 interactions. This command will trigger a per-atom list of 1-5 +neighbors to be generated. The AMOEBA and HIPPO force fields define +their own custom weighting factors for all the 1-2, 1-3, 1-4, 1-5 +terms which in the Tinker PRM and KEY files; they can be different for +different terms in the force field. -.. code-block:: bash +In addition to the list above, these command doc pages have additional +details: - % python tinker2lmp.py -xyz tinker.xyz -amoeba protein.prm.amoeba -data lmp.data # AMOEBA for non-periodic systems - % python tinker2lmp.py -xyz tinker.xyz -amoeba protein.prm.amoeba -data lmp.data -pbc 10.0 20.0 15.0 # AMOEBA for periodic systems - % python tinker2lmp.py -xyz tinker.xyz -hippo water.prm.hippo -data lmp.data # HIPPO for non-periodic systems - % python tinker2lmp.py -xyz tinker.xyz -hippo water.prm.hippo -data lmp.data -pbc 10.0 20.0 15.0 # HIPPO for periodic systems - -Note that two input files are needed and a LAMMPS data file (lmp.data) -is produced. The data file will have information on Tinker atom types -and AMOEBA/HIPPO force field parameters for bonds, angles, and -dihedrals. - -The first input is an XYZ file listing all the atoms in the -system. - -NOTE: is this a Tinker-augmented-XYZ format or standard? In either -case, how do we suggest LAMMPS users come up with these files? - -The second input is an AMOEBA or HIPPO PRM (force field) file. The -format of these files is defined by Tinker. A few such files are -provided in the LAMMPS potentials directory. Others may be available -in the Tinker distribution or from the Ponder group. - -The pair_coeff command should specify the same PRM file, and -optionally a Tinker-format KEY file. See the :doc:`pair_style amoeba -` doc page for more information about Tinker PRM and KEY -files. - -Finally, the :doc:`special_bonds ` command is used to -set all LJ and Coulombic 1-2, 1-3, 1-4 weighting factors to non-zero -and non-unity values, and to generate a per-atom list of 1-5 neighbors -as well. This is to insure all bond-topology neighbors are included -in the neighbor lists used by AMOEBA/HIPPO. These force fields apply -their own custom weighting factors to all these terms, including the -1-5 neighbors. +* :doc:`atom_style amoeba ` +* :doc:`fix property/atom ` +* :doc:`special_bonds ` ---------- -These command doc pages have additional details: +Tinker PRM and KEY files -* :doc:`pair_style amoeba or hippo ` -* :doc:`bond_style amoeba ` -* :doc:`angle_style amoeba ` -* :doc:`dihedral_style amoeba ` -* :doc:`fix property/atom ` -* :doc:`special_bonds ` +A Tinker PRM file is composed of sections, each of which has multiple +lines. This is the list of sections LAMMPS knows how to parse and +use. Any other sections are skipped: + +* Angle Bending Parameters +* Atom Type Definitions +* Atomic Multipole Parameters +* Bond Stretching Parameters +* Charge Penetration Parameters +* Charge Transfer Parameters +* Dipole Polarizability Parameters +* Dispersion Parameters +* Force Field Definition +* Literature References +* Out-of-Plane Bend Parameters +* Pauli Repulsion Parameters +* Pi-Torsion Parameters +* Stretch-Bend Parameters +* Torsion-Torsion Parameters +* Torsional Parameters +* Urey-Bradley Parameters +* Van der Waals Pair Parameters +* Van der Waals Parameters + +A Tinker KEY file is composed of lines, each of which has a keyword, +which can be followed by zero or more parameters. This is the list of +keywords LAMMPS knows how to parse and use in the same manner Tinker +does. Any other keywords are skipped. The value following the equal +sign is the default value for the keyword if it is not specified, or +if the keyfile in the :doc:`pair_coeff ` command is +specified as NULL: + +* a-axis = 0.0 +* b-axis = 0.0 +* c-axis = 0.0 +* ctrn-cutoff = 6.0 +* ctrn-taper = 0.9 * ctrn-cutoff +* cutoff +* delta-halgren = 0.07 +* dewald = no use of long-range dispersion unless specified +* dewald-alpha = 0.4 +* dewald-cutoff = 7.0 +* dispersion-cutoff = 9.0 +* dispersion-taper = 9.0 * dispersion-cutoff +* dpme-grid +* dpme-order = 4 +* ewald = no use of long-range electrostatics unless specified +* ewald-alpha = 0.4 +* ewald-cutoff = 7.0 +* gamma-halgren = 0.12 +* mpole-cutoff = 9.0 +* mpole-taper 0.65 * mpole-cutoff +* pcg-guess = enabled (default) +* pcg-noguess = disable pcg-guess +* pcg-noprecond = disable pcg-precond +* pcg-peek = 1.0 +* pcg-precond = enabled (default) +* pewald-alpha = 0.4 +* pme-grid +* pme-order = 5 +* polar-eps = 1.0e-6 +* polar-iter = 100 +* polar-predict = no prediction operation unless specified +* ppme-order = 5 +* repulsion-cutoff = 6.0 +* repulsion-taper = 0.9 * repulsion-cutoff +* taper +* usolve-cutoff = 4.5 +* usolve-diag = 2.0 +* vdw-cutoff = 9.0 +* vdw-taper = 0.9 * vdw-cutoff + +---------- + +Tinker2lmp.py tool + +This conversion tool is found in the tools/tinker directory. +As listed in examples/amoeba/README, these commands produce +the data files found in examples/amoeba, and also illustrate +all the options available to use with the tinker2lmp.py script: + +.. code-block:: bash + + % python tinker2lmp.py -xyz water_dimer.xyz -amoeba amoeba_water.prm -data data.water_dimer.amoeba # AMOEBA non-periodic system + % python tinker2lmp.py -xyz water_dimer.xyz -hippo hippo_water.prm -data data.water_dimer.hippo # HIPPO non-periodic system + % python tinker2lmp.py -xyz water_box.xyz -amoeba amoeba_water.prm -data data.water_box.amoeba -pbc 18.643 18.643 18.643 # AMOEBA periodic system + % python tinker2lmp.py -xyz water_box.xyz -hippo hippo_water.prm -data data.water_box.hippo -pbc 18.643 18.643 18.643 # HIPPO periodic system + % python tinker2lmp.py -xyz ubiquitin.xyz -amoeba amoeba_ubiquitin.prm -data data.ubiquitin.new -pbc 54.99 41.91 41.91 -bitorsion bitorsion.ubiquitin.data.new # system with bitorsions + +Switches and their arguments may be specified in any order. + +The -xyz switch is required and specifies an input XYZ file as an +argument. The format of this file is an extended XYZ format used by +Tinker for its input. Example *.xyz files are in the examples/amoeba +directory. The file lists the atoms in the system. Each atom has the +following information: Tinker species name (ignored by LAMMPS), xyz +coordinates, Tinker numeric type, and a list of atom IDs the atom is +bonded to. + +NOTE: is this a Tinker-unique augmented XYZ format or standard? Where +can a LAMMPS user get or generate this file for a system they want +to simulate? + +The -amoeba or -hippo switch is required. It specifies an input +AMOEBA or HIPPO PRM force field file as an argument. This should be +the same file used by the :doc:`pair_style ` command in +the input script. + +The -data switch is required. It specifies an output file name for +the LAMMPS data file that will be produced. + +For periodic systems, the -pbc switch is required. It specifies the +periodic box size for each dimension (x,y,z). For a Tinker simulation +these are specified in the KEY file. + +NOTE: What about a system with a free surface. What about a triclinic +box. + +The -bitorsion switch is only needed if the system contains Tinker +bitorsion interactions. The data for each type of bitorsion +interaction will be written to the specified file, and read by the +:doc:`fix amoeba/bitorsion ` command. The data +includes 2d arrays of values to which splines are fit, and thus is not +compatible with the LAMMPS data file format. ---------- diff --git a/doc/src/angle_amoeba.rst b/doc/src/angle_amoeba.rst new file mode 100644 index 0000000000..9a20299f45 --- /dev/null +++ b/doc/src/angle_amoeba.rst @@ -0,0 +1,137 @@ +.. index:: angle_style amoeba + +angle_style amoeba command +========================== + + +Syntax +"""""" + +.. code-block:: LAMMPS + + angle_style amoeba + +Examples +"""""""" + +.. code-block:: LAMMPS + + angle_style amoeba + angle_coeff * 75.0 -25.0 1.0 0.3 0.02 0.003 + angle_coeff * ba 3.6551 24.895 1.0119 1.5228 + angle_coeff * ub -7.6 1.5537 + +Description +""""""""""" + +The *amoeba* angle style uses the potential + +.. math:: + + E & = E_a + E_{ba} + E_{ub} \\ + E_a = K_2\left(\theta - \theta_0\right)^2 + K_3\left(\theta - \theta_0\right)^3 + K_4\left(\theta - \theta_0\right)^4 + K_5\left(\theta - \theta_0\right)^5 + K_6\left(\theta - \theta_0\right)^6 + E_{ba} & = N_1 (r_{ij} - r_1) (\theta - \theta_0) + N_2(r_{jk} - r_2)(\theta - \theta_0) + E_{ub} & = K_{ub} (r_{ik} - r_{ub})^2) + +where :math:`E_a` is the angle term, :math:`E_{ba}` is a bond-angle +term, ::math:`E_{ub}` is a Urey-Bradley bond term, :math:`\theta_0` is +the equilibrium angle, :math:`r_1` and :math:`r_2` are the equilibrium +bond lengths, and :math:`r_{ub}` is the equilibrium Urey-Bradley bond +length between atoms I and K in the angle IJK. + +These formulas match how the Tinker MD code does its angle +calculations for the AMOEBA and HIPPO force fields. See the +doc:`Howto amoeba ` doc page for more information about +the implemention of AMOEBA and HIPPO in LAMMPS. + +Note that the :math:`E_a` and :math:`E_{ba}` formulas are identical to +those used for the :doc:`angle_style class2/p6 ` +command, however there is no bond-bond cross term formula for +:math:`E_{bb}`. Additionally, there is a :math:`E_{ub}` term for a +Urey-Bradley bond. It is effectively a harmonic bond between the I +and K atoms of angle IJK, even though that bond is not enumerated in +the "Bonds" section of the data file. + +There are also two ways that Tinker computes the angle :math:`\theta` +in the :math:`E_a` formula. The first is the standard way of treating +IJK as an "in-plane" angle. The second is an "out-of-plane" method +which Tinker may use if the center atom J in the angle is bonded to +one additional atom in addition to I and K. In this case, all 4 atoms +are used to compute the :math:`E_a` formula, resulting in forces on +all 4 atoms. In the Tinker PRM file, these 2 options are denoted by +"angle" versus "anglep" entries in the "Angle Bending Parameters" +section of the PRM force field file. The *pflag* coefficient +described below selects between the 2 options. + +---------- + + +Coefficients for the :math:`E_a`, :math:`E_{bb}`, and :math:`E_{ub}` +formulas must be defined for each angle type via the :doc:`angle_coeff +` command as in the example above, or in the data file or +restart files read by the :doc:`read_data ` or +:doc:`read_restart ` commands. + +These are the 8 coefficients for the :math:`E_a` formula: + +* pflag = 0 or 1 +* ublag = 0 or 1 +* :math:`\theta_0` (degrees) +* :math:`K_2` (energy) +* :math:`K_3` (energy) +* :math:`K_4` (energy) +* :math:`K_5` (energy) +* :math:`K_6` (energy) + +A pflag value of 0 vs 1 selects between the "in-plane" and +"out-of-plane" options described above. Ubflag is 1 if there is a +Urey-Bradley term associated with this angle type, else it is 0. +:math:`\theta_0` is specified in degrees, but LAMMPS converts it to +radians internally; hence the various :math:`K` are effectively energy +per radian\^2 or radian\^3 or radian\^4 or radian\^5 or radian\^6. + +For the :math:`E_{ba}` formula, each line in a :doc:`angle_coeff +` command in the input script lists 5 coefficients, the +first of which is "ba" to indicate they are BondAngle coefficients. +In a data file, these coefficients should be listed under a "BondAngle +Coeffs" heading and you must leave out the "ba", i.e. only list 4 +coefficients after the angle type. + +* ba +* :math:`N_1` (energy/distance\^2) +* :math:`N_2` (energy/distance\^2) +* :math:`r_1` (distance) +* :math:`r_2` (distance) + +The :math:`\theta_0` value in the :math:`E_{ba}` formula is not specified, +since it is the same value from the :math:`E_a` formula. + +For the :math:`E_{ub}` formula, each line in a :doc:`angle_coeff +` command in the input script lists 3 coefficients, the +first of which is "ub" to indicate they are UreyBradley coefficients. +In a data file, these coefficients should be listed under a +"UreyBradley Coeffs" heading and you must leave out the "ub", +i.e. only list 2 coefficients after the angle type. + +* ub +* :math:`K_{ub}` (energy/distance\^2) +* :math:`r_{ub}` (distance) + +---------- + +Restrictions +"""""""""""" + +This angle style can only be used if LAMMPS was built with the AMOEBA +package. See the :doc:`Build package ` doc page for +more info. + +Related commands +"""""""""""""""" + +:doc:`angle_coeff ` + +Default +""""""" + +none diff --git a/doc/src/angle_class2.rst b/doc/src/angle_class2.rst index f257d96dc3..418df242aa 100644 --- a/doc/src/angle_class2.rst +++ b/doc/src/angle_class2.rst @@ -24,7 +24,7 @@ Examples .. code-block:: LAMMPS angle_style class2 - angle_coeff * 75.0 + angle_coeff * 75.0 25.0 0.3 0.002 angle_coeff 1 bb 10.5872 1.0119 1.5228 angle_coeff * ba 3.6551 24.895 1.0119 1.5228 diff --git a/doc/src/angle_style.rst b/doc/src/angle_style.rst index 0715625d45..88b135918a 100644 --- a/doc/src/angle_style.rst +++ b/doc/src/angle_style.rst @@ -73,6 +73,7 @@ of (g,i,k,o,t) to indicate which accelerated styles exist. * :doc:`zero ` - topology but no interactions * :doc:`hybrid ` - define multiple styles of angle interactions +* :doc:`amoeba ` - AMOEBA angle * :doc:`charmm ` - CHARMM angle * :doc:`class2 ` - COMPASS (class 2) angle * :doc:`class2/p6 ` - COMPASS (class 2) angle expanded to 6th order diff --git a/doc/src/atom_style.rst b/doc/src/atom_style.rst index bade8c2f79..55b661555b 100644 --- a/doc/src/atom_style.rst +++ b/doc/src/atom_style.rst @@ -10,7 +10,7 @@ Syntax atom_style style args -* style = *angle* or *atomic* or *body* or *bond* or *charge* or *dipole* or *dpd* or *edpd* or *electron* or *ellipsoid* or *full* or *line* or *mdpd* or *molecular* or *oxdna* or *peri* or *smd* or *sph* or *sphere* or *spin* or *tdpd* or *tri* or *template* or *hybrid* +* style = *amoeba* or *angle* or *atomic* or *body* or *bond* or *charge* or *dipole* or *dpd* or *edpd* or *electron* or *ellipsoid* or *full* or *line* or *mdpd* or *molecular* or *oxdna* or *peri* or *smd* or *sph* or *sphere* or *spin* or *tdpd* or *tri* or *template* or *hybrid* .. parsed-literal:: @@ -77,6 +77,8 @@ coordinates, velocities, atom IDs and types. See the :doc:`set ` commands for info on how to set these various quantities. ++--------------+-----------------------------------------------------+--------------------------------------+ +| *amoeba* | molecular + charge + 1/5 neighbors | AMOEBA/HIPPO polarized force fields | +--------------+-----------------------------------------------------+--------------------------------------+ | *angle* | bonds and angles | bead-spring polymers with stiffness | +--------------+-----------------------------------------------------+--------------------------------------+ @@ -134,15 +136,18 @@ quantities. .. note:: It is possible to add some attributes, such as a molecule ID, to - atom styles that do not have them via the :doc:`fix property/atom ` command. This command also - allows new custom attributes consisting of extra integer or - floating-point values to be added to atoms. See the :doc:`fix property/atom ` page for examples of cases - where this is useful and details on how to initialize, access, and - output the custom values. + atom styles that do not have them via the :doc:`fix property/atom + ` command. This command also allows new custom + attributes consisting of extra integer or floating-point values to + be added to atoms. See the :doc:`fix property/atom + ` page for examples of cases where this is + useful and details on how to initialize, access, and output the + custom values. All of the above styles define point particles, except the *sphere*, *ellipsoid*, *electron*, *peri*, *wavepacket*, *line*, *tri*, and -*body* styles, which define finite-size particles. See the :doc:`Howto spherical ` page for an overview of using +*body* styles, which define finite-size particles. See the +:doc:`Howto spherical ` page for an overview of using finite-size particle models with LAMMPS. All of the point-particle styles assign mass to particles on a @@ -266,16 +271,17 @@ showing the use of the *template* atom style versus *molecular*. .. note:: - When using the *template* style with a :doc:`molecule template ` that contains multiple molecules, you should - insure the atom types, bond types, angle_types, etc in all the - molecules are consistent. E.g. if one molecule represents H2O and - another CO2, then you probably do not want each molecule file to - define 2 atom types and a single bond type, because they will conflict - with each other when a mixture system of H2O and CO2 molecules is - defined, e.g. by the :doc:`read_data ` command. Rather the - H2O molecule should define atom types 1 and 2, and bond type 1. And - the CO2 molecule should define atom types 3 and 4 (or atom types 3 and - 2 if a single oxygen type is desired), and bond type 2. + When using the *template* style with a :doc:`molecule template + ` that contains multiple molecules, you should insure the + atom types, bond types, angle_types, etc in all the molecules are + consistent. E.g. if one molecule represents H2O and another CO2, + then you probably do not want each molecule file to define 2 atom + types and a single bond type, because they will conflict with each + other when a mixture system of H2O and CO2 molecules is defined, + e.g. by the :doc:`read_data ` command. Rather the H2O + molecule should define atom types 1 and 2, and bond type 1. And + the CO2 molecule should define atom types 3 and 4 (or atom types 3 + and 2 if a single oxygen type is desired), and bond type 2. For the *body* style, the particles are arbitrary bodies with internal attributes defined by the "style" of the bodies, which is specified by @@ -352,6 +358,8 @@ Many of the styles listed above are only enabled if LAMMPS was built with a specific package, as listed below. See the :doc:`Build package ` page for more info. +The *amoeba* style is part of the AMOEBA package. + The *angle*, *bond*, *full*, *molecular*, and *template* styles are part of the MOLECULE package. @@ -363,9 +371,11 @@ The *dipole* style is part of the DIPOLE package. The *peri* style is part of the PERI package for Peridynamics. -The *oxdna* style is part of the CG-DNA package for coarse-grained simulation of DNA and RNA. +The *oxdna* style is part of the CG-DNA package for coarse-grained +simulation of DNA and RNA. -The *electron* style is part of the EFF package for :doc:`electronic force fields `. +The *electron* style is part of the EFF package for :doc:`electronic +force fields `. The *dpd* style is part of the DPD-REACT package for dissipative particle dynamics (DPD). @@ -376,7 +386,8 @@ dissipative particle dynamics (mDPD), and transport dissipative particle dynamics (tDPD), respectively. The *sph* style is part of the SPH package for smoothed particle -hydrodynamics (SPH). See `this PDF guide `_ to using SPH in LAMMPS. +hydrodynamics (SPH). See `this PDF guide +`_ to using SPH in LAMMPS. The *mesont* style is part of the MESONT package. diff --git a/doc/src/fix.rst b/doc/src/fix.rst index 81c0c87320..9e9089b312 100644 --- a/doc/src/fix.rst +++ b/doc/src/fix.rst @@ -170,6 +170,8 @@ accelerated styles exist. * :doc:`adapt/fep ` - enhanced version of fix adapt * :doc:`addforce ` - add a force to each atom * :doc:`addtorque ` - add a torque to a group of atoms +* :doc:`amoeba/bitorsion ` - torsion/torsion terms in AMOEBA force field +* :doc:`amoeba/pitorsion ` - 6-body terms in AMOEBA force field * :doc:`append/atoms ` - append atoms to a running simulation * :doc:`atc ` - initiates a coupled MD/FE simulation * :doc:`atom/swap ` - Monte Carlo atom type swapping @@ -194,7 +196,7 @@ accelerated styles exist. * :doc:`box/relax ` - relax box size during energy minimization * :doc:`charge/regulation ` - Monte Carlo sampling of charge regulation * :doc:`client/md ` - MD client for client/server simulations -* :doc:`cmap ` - enables CMAP cross-terms of the CHARMM force field +* :doc:`cmap ` - CMAP torsion/torsion terms in CHARMM force field * :doc:`colvars ` - interface to the collective variables "Colvars" library * :doc:`controller ` - apply control loop feedback mechanism * :doc:`deform ` - change the simulation box size/shape diff --git a/doc/src/fix_amoeba_bitorsion.rst b/doc/src/fix_amoeba_bitorsion.rst new file mode 100644 index 0000000000..b05c2128d6 --- /dev/null +++ b/doc/src/fix_amoeba_bitorsion.rst @@ -0,0 +1,167 @@ +.. index:: fix amoeba/bitorsion + +fix amoeba/bitorsion command +================ + +Syntax +"""""" + +.. parsed-literal:: + + fix ID group-ID ameoba/bitorsion filename + +* ID, group-ID are documented in :doc:`fix ` command +* amoeba/bitorsion = style name of this fix command +* filename = force-field file with AMOEBA bitorsion coefficients + +Examples +"""""""" + +.. code-block:: LAMMPS + + fix bit all amoeba/bitorsion bitorsion.ubiquitin.data + read_data proteinX.data fix bit bitorsions BiTorsions + fix_modify bit energy yes + +Description +""""""""""" + +This command enables 5-body torsion/torsion interactions to be added +to simulations which use the AMOEBA and HIPPO force fields. It +matches how the Tinker MD code computes its torsion/torsion +interactions for the AMOEBA and HIPPO force fields. See the +doc:`Howto amoeba ` doc page for more information about +the implemention of AMOEBA and HIPPO in LAMMPS. + +Bitorsion interactions add additional potential energy contributions +to pairs of overlapping phi-psi dihedrals of amino-acids, which are +important to properly represent their conformational behavior. + +The examples/amoeba directory has a sample input script and data file +for ubiquitin, which illustrates use of the fix amoeba/bitorsion +command. + +As in the example above, this fix should be used before reading a data +file that contains a listing of bitorsion interactions. The +*filename* specified should contain the bitorsion parameters for the +AMOEBA or HIPPO force field. + +The data file read by the "read_data" must contain the topology of all +the bitorsion interactions, similar to the topology data for bonds, +angles, dihedrals, etc. Specially it should have a line like this in +its header section: + +.. parsed-literal:: + + N bitorsions + +where N is the number of bitorsion 5-body interactions. It should +also have a section in the body of the data file like this with N +lines: + +.. parsed-literal:: + + BiTorsions + + 1 1 8 10 12 18 20 + 2 5 18 20 22 25 27 + [...] + N 3 314 315 317 318 330 + +The first column is an index from 1 to N to enumerate the bitorsion +5-atom tuples; it is ignored by LAMMPS. The second column is the +"type" of the interaction; it is an index into the bitorsion force +field file. The remaining 5 columns are the atom IDs of the atoms in +the two 4-atom dihedrals that overlap to create the bitorsion 5-body +interaction. Note that the "bitorsions" and "BiTorsions" keywords for +the header and body sections match those specified in the read_data +command following the data file name; see the :doc:`read_data +` page for more details. + +The data file should be generated by using the +tools/tinker/tinker2lmp.py conversion script which creates a LAMMPS +data file from Tinker input files, including its PRM file which +contains the parameters necessary for computing bitorsion +interactions. The script must be invoked with the optional +"-bitorsion" flag to do this; see the example for the ubiquitin system +in the tools/tinker/README file. The same conversion script also +creates the file of bitorsion coefficient data which is read by this +command. + +The potential energy associated with bitorsion interactions can be +output as described below. It can also be included in the total +potential energy of the system, as output by the :doc:`thermo_style +` command, if the :doc:`fix_modify energy ` +command is used, as in the example above. See the note below about +how to include the bitorsion energy when performing an :doc:`energy +minimization `. + +---------- + +Restart, fix_modify, output, run start/stop, minimize info +""""""""""""""""""""""""""""""""""""""""""""""""""""""""""" + +This fix writes the list of bitorsion interactions to :doc:`binary +restart files `. See the :doc:`read_restart ` +command for info on how to re-specify a fix in an input script that +reads a restart file, so that the operation of the fix continues in an +uninterrupted fashion. + +The :doc:`fix_modify ` *energy* option is supported by +this fix to add the potential energy of the bitorsion interactions to +both the global potential energy and peratom potential energies of the +system as part of :doc:`thermodynamic output ` or output +by the :doc:`compute pe/atom ` command. The default +setting for this fix is :doc:`fix_modify energy yes `. + +The :doc:`fix_modify ` *virial* option is supported by +this fix to add the contribution due to the bitorsion interactions to +both the global pressure and per-atom stress of the system via the +:doc:`compute pressure ` and :doc:`compute +stress/atom ` commands. The former can be +accessed by :doc:`thermodynamic output `. The default +setting for this fix is :doc:`fix_modify virial yes `. + +This fix computes a global scalar which can be accessed by various +:doc:`output commands `. The scalar is the potential +energy discussed above. The scalar value calculated by this fix is +"extensive". + +No parameter of this fix can be used with the *start/stop* keywords of +the :doc:`run ` command. + +The forces due to this fix are imposed during an energy minimization, +invoked by the :doc:`minimize ` command. + +The :doc:`fix_modify ` *respa* option is supported by this +fix. This allows to set at which level of the :doc:`r-RESPA +` integrator the fix is adding its forces. Default is the +outermost level. + +.. note:: + + For energy minimization, if you want the potential energy + associated with the bitorsion terms forces to be included in the + total potential energy of the system (the quantity being + minimized), you MUST not disable the :doc:`fix_modify ` + *energy* option for this fix. + +Restrictions +"""""""""""" + +To function as expected this fix command must be issued *before* a +:doc:`read_data ` command but *after* a :doc:`read_restart +` command. + +This fix can only be used if LAMMPS was built with the AMOEBA package. +See the :doc:`Build package ` page for more info. + +Related commands +"""""""""""""""" + +:doc:`fix_modify `, :doc:`read_data ` + +Default +""""""" + +none diff --git a/doc/src/fix_amoeba_pitorsion.rst b/doc/src/fix_amoeba_pitorsion.rst new file mode 100644 index 0000000000..b80ca3a285 --- /dev/null +++ b/doc/src/fix_amoeba_pitorsion.rst @@ -0,0 +1,186 @@ +.. index:: fix amoeba/pitorsion + +fix amoeba/pitorsion command +================ + +Syntax +"""""" + +.. parsed-literal:: + + fix ID group-ID ameoba/pitorsion + +* ID, group-ID are documented in :doc:`fix ` command +* amoeba/pitorsion = style name of this fix command + +Examples +"""""""" + +.. code-block:: LAMMPS + + fix pit all amoeba/pitorsion + read_data proteinX.data fix pit "pitorsion types" "PiTorsion Coeffs" & + fix pit pitorsions PiTorsions + fix_modify pit energy yes + +Description +""""""""""" + +This command enables 6-body pitorsion interactions to be added to +simulations which use the AMOEBA and HIPPO force fields. It matches +how the Tinker MD code computes its pitorsion interactions for the +AMOEBA and HIPPO force fields. See the doc:`Howto amoeba +` doc page for more information about the implemention +of AMOEBA and HIPPO in LAMMPS. + +Pitorsion interactions add additional potential energy contributions +to 6-tuples of atoms IJKLMN which have a bond between atoms K and L, +where both K and L are additionally bonded to exactly two other atoms. +Namely K is also bonded to I and J. And L is also bonded to M and N. + +The examples/amoeba directory has a sample input script and data file +for ubiquitin, which illustrates use of the fix amoeba/pitorsion +command. + +As in the example above, this fix should be used before reading a data +file that contains a listing of pitorsion interactions. The +*filename* specified should contain the pitorsion parameters for the +AMOEBA or HIPPO force field. + +The data file read by the "read_data" must contain the topology of all +the pitorsion interactions, similar to the topology data for bonds, +angles, dihedrals, etc. Specially it should have two lines like these +in its header section: + +.. parsed-literal:: + + M pitorsion types + N pitorsions + +where N is the number of pitorsion 5-body interactions and M is the +number of pitorsion types. It should also have two sections in the body +of the data file like these with M and N lines: + +.. parsed-literal:: + + PiTorsion Coeffs + + 1 6.85 + 2 10.2 + [...] + M 6.85 + +.. parsed-literal:: + + PiTorsions + + 1 1 8 10 12 18 20 + 2 5 18 20 22 25 27 + [...] + N 3 314 315 317 318 330 + +For PiTorsion Coeffs, the first column is an index from 1 to M to +enumerate the pitorsion types. The second column is the single +coefficient needed for each type. + +For PiTorsions, the first column is an index from 1 to N to enumerate +the pitorsion 5-atom tuples; it is ignored by LAMMPS. The second +column is the "type" of the interaction; it is an index into the +PiTorsion Coeffs. The remaining 5 columns are the atom IDs of the +atoms in the two 4-atom dihedrals that overlap to create the pitorsion +5-body interaction. + +Note that the "pitorsion types" and "pitorsions" and "PiTorsion +Coeffs" and "PiTorsions" keywords for the header and body sections +match those specified in the read_data command following the data file +name; see the :doc:`read_data ` page for more details. + +A data file containing pitorsion 6-body interactions can be generated +from using the tinker2lmp.py script in the tools/tinker directory of +the LAMMPS distribution. See the examples for its use for the +ubiquitin system in the tools/tinker/README file. + +The data file should be generated by using the +tools/tinker/tinker2lmp.py conversion script which creates a LAMMPS +data file from Tinker input files, including its PRM file which +contains the parameters necessary for computing pitorsion +interactions. See the example for the ubiquitin system in the +tools/tinker/README file. + +The potential energy associated with pitorsion interactions can be +output as described below. It can also be included in the total +potential energy of the system, as output by the :doc:`thermo_style +` command, if the :doc:`fix_modify energy ` +command is used, as in the example above. See the note below about +how to include the pitorsion energy when performing an :doc:`energy +minimization `. + +---------- + +Restart, fix_modify, output, run start/stop, minimize info +""""""""""""""""""""""""""""""""""""""""""""""""""""""""""" + +This fix writes the list of pitorsion interactions to :doc:`binary +restart files `. See the :doc:`read_restart ` +command for info on how to re-specify a fix in an input script that +reads a restart file, so that the operation of the fix continues in an +uninterrupted fashion. + +The :doc:`fix_modify ` *energy* option is supported by +this fix to add the potential energy of the pitorsion interactions to +both the global potential energy and peratom potential energies of the +system as part of :doc:`thermodynamic output ` or output +by the :doc:`compute pe/atom ` command. The default +setting for this fix is :doc:`fix_modify energy yes `. + +The :doc:`fix_modify ` *virial* option is supported by +this fix to add the contribution due to the pitorsion interactions to +both the global pressure and per-atom stress of the system via the +:doc:`compute pressure ` and :doc:`compute +stress/atom ` commands. The former can be +accessed by :doc:`thermodynamic output `. The default +setting for this fix is :doc:`fix_modify virial yes `. + +This fix computes a global scalar which can be accessed by various +:doc:`output commands `. The scalar is the potential +energy discussed above. The scalar value calculated by this fix is +"extensive". + +No parameter of this fix can be used with the *start/stop* keywords of +the :doc:`run ` command. + +The forces due to this fix are imposed during an energy minimization, +invoked by the :doc:`minimize ` command. + +The :doc:`fix_modify ` *respa* option is supported by this +fix. This allows to set at which level of the :doc:`r-RESPA +` integrator the fix is adding its forces. Default is the +outermost level. + +.. note:: + + For energy minimization, if you want the potential energy + associated with the pitorsion terms forces to be included in the + total potential energy of the system (the quantity being + minimized), you MUST not disable the :doc:`fix_modify ` + *energy* option for this fix. + +Restrictions +"""""""""""" + +To function as expected this fix command must be issued *before* a +:doc:`read_data ` command but *after* a :doc:`read_restart +` command. + +This fix can only be used if LAMMPS was built with the AMOEBA package. +See the :doc:`Build package ` page for more info. + +Related commands +"""""""""""""""" + +:doc:`fix_modify `, :doc:`read_data ` + +Default +""""""" + +none diff --git a/doc/src/fix_cmap.rst b/doc/src/fix_cmap.rst index 6475e538a2..19d8cd2d52 100644 --- a/doc/src/fix_cmap.rst +++ b/doc/src/fix_cmap.rst @@ -26,13 +26,13 @@ Examples Description """"""""""" -This command enables CMAP cross-terms to be added to simulations which -use the CHARMM force field. These are relevant for any CHARMM model -of a peptide or protein sequences that is 3 or more amino-acid -residues long; see :ref:`(Buck) ` and :ref:`(Brooks) ` -for details, including the analytic energy expressions for CMAP -interactions. The CMAP cross-terms add additional potential energy -contributions to pairs of overlapping phi-psi dihedrals of +This command enables CMAP 5-body interactions to be added to +simulations which use the CHARMM force field. These are relevant for +any CHARMM model of a peptide or protein sequences that is 3 or more +amino-acid residues long; see :ref:`(Buck) ` and :ref:`(Brooks) +` for details, including the analytic energy expressions for +CMAP interactions. The CMAP 5-body terms add additional potential +energy contributions to pairs of overlapping phi-psi dihedrals of amino-acids, which are important to properly represent their conformational behavior. @@ -47,15 +47,15 @@ lammps/potentials directory: charmm22.cmap and charmm36.cmap. The data file read by the "read_data" must contain the topology of all the CMAP interactions, similar to the topology data for bonds, angles, -dihedrals, etc. Specially it should have a line like this -in its header section: +dihedrals, etc. Specially it should have a line like this in its +header section: .. parsed-literal:: N crossterms -where N is the number of CMAP cross-terms. It should also have a section -in the body of the data file like this with N lines: +where N is the number of CMAP 5-body interactions. It should also +have a section in the body of the data file like this with N lines: .. parsed-literal:: @@ -66,28 +66,29 @@ in the body of the data file like this with N lines: [...] N 3 314 315 317 318 330 -The first column is an index from 1 to N to enumerate the CMAP terms; -it is ignored by LAMMPS. The second column is the "type" of the -interaction; it is an index into the CMAP force field file. The +The first column is an index from 1 to N to enumerate the CMAP 5-atom +tuples; it is ignored by LAMMPS. The second column is the "type" of +the interaction; it is an index into the CMAP force field file. The remaining 5 columns are the atom IDs of the atoms in the two 4-atom -dihedrals that overlap to create the CMAP 5-body interaction. Note -that the "crossterm" and "CMAP" keywords for the header and body -sections match those specified in the read_data command following the -data file name; see the :doc:`read_data ` page for -more details. +dihedrals that overlap to create the CMAP interaction. Note that the +"crossterm" and "CMAP" keywords for the header and body sections match +those specified in the read_data command following the data file name; +see the :doc:`read_data ` page for more details. -A data file containing CMAP cross-terms can be generated from a PDB -file using the charmm2lammps.pl script in the tools/ch2lmp directory -of the LAMMPS distribution. The script must be invoked with the -optional "-cmap" flag to do this; see the tools/ch2lmp/README file for -more information. +A data file containing CMAP 5-body interactions can be generated from +a PDB file using the charmm2lammps.pl script in the tools/ch2lmp +directory of the LAMMPS distribution. The script must be invoked with +the optional "-cmap" flag to do this; see the tools/ch2lmp/README file +for more information. The same conversion script also creates the +file of CMAP coefficient data which is read by this command. The potential energy associated with CMAP interactions can be output as described below. It can also be included in the total potential -energy of the system, as output by the -:doc:`thermo_style ` command, if the :doc:`fix_modify energy ` command is used, as in the example above. See -the note below about how to include the CMAP energy when performing an -:doc:`energy minimization `. +energy of the system, as output by the :doc:`thermo_style +` command, if the :doc:`fix_modify energy ` +command is used, as in the example above. See the note below about +how to include the CMAP energy when performing an :doc:`energy +minimization `. ---------- @@ -134,10 +135,11 @@ outermost level. .. note:: - If you want the potential energy associated with the CMAP terms - forces to be included in the total potential energy of the system - (the quantity being minimized), you MUST not disable the - :doc:`fix_modify ` *energy* option for this fix. + For energy minimization, if you want the potential energy + associated with the CMAP terms forces to be included in the total + potential energy of the system (the quantity being minimized), you + MUST not disable the :doc:`fix_modify ` *energy* option + for this fix. Restrictions """""""""""" diff --git a/doc/src/improper_amoeba.rst b/doc/src/improper_amoeba.rst new file mode 100644 index 0000000000..75f32abaf7 --- /dev/null +++ b/doc/src/improper_amoeba.rst @@ -0,0 +1,77 @@ +.. index:: improper_style amoeba + +improper_style harmonic command +=============================== + +Syntax +"""""" + +.. code-block:: LAMMPS + + improper_style amoeba + +Examples +"""""""" + +.. code-block:: LAMMPS + + improper_style amoeba + improper_coeff 1 49.6 + +Description +""""""""""" + +The *amoeba* improper style uses the potential + +.. math:: + + E = K (\chi)^2 + +where :math:`\chi` is the improper angle and :math:`K` is a prefactor. +Note that the usual 1/2 factor is included in :math:`K`. + +This formula seems like a simplified version of the formula for the +:doc:`improper_style harmonic ` command with +:math:`\chi_0` = 0.0. However the computation of the angle +:math:`\chi` is done differently to match how the Tinker MD code +computes its out-of-plane improper for the AMOEBA and HIPPO force +fields. See the doc:`Howto amoeba ` doc page for more +information about the implemention of AMOEBA and HIPPO in LAMMPS. + +If the 4 atoms in an improper quadruplet (listed in the data file read +by the :doc:`read_data ` command) are ordered I,J,K,L then +atoms I,K,L form a plane and atom J is out-of-place. The angle +:math:`\chi_0` is computed as the Allinger angle which is defined as +the angle between the plane of I,K,L, and the vector from atom I to +atom J. + +The following coefficient must be defined for each improper type via +the :doc:`improper_coeff ` command as in the example +above, or in the data file or restart files read by the +:doc:`read_data ` or :doc:`read_restart ` +commands: + +* :math:`K` (energy) + +Note that the angle :math:`\chi` is computed in radians; hence +:math:`K` is effectively energy per radian\^2. + +---------- + +Restrictions +"""""""""""" + +This improper style can only be used if LAMMPS was built with the +AMOEBA package. See the :doc:`Build package ` doc page +for more info. + +Related commands +"""""""""""""""" + +:doc:`improper_coeff `, `improper_harmonic +:doc:` + +Default +""""""" + +none diff --git a/doc/src/improper_style.rst b/doc/src/improper_style.rst index ca7c31a923..3fd7eeb1e8 100644 --- a/doc/src/improper_style.rst +++ b/doc/src/improper_style.rst @@ -77,6 +77,7 @@ more of (g,i,k,o,t) to indicate which accelerated styles exist. * :doc:`zero ` - topology but no interactions * :doc:`hybrid ` - define multiple styles of improper interactions +* :doc:`amoeba ` - AMOEBA out-of-plane improper * :doc:`class2 ` - COMPASS (class 2) improper * :doc:`cossq ` - improper with a cosine squared term * :doc:`cvff ` - CVFF improper diff --git a/doc/src/pair_amoeba.rst b/doc/src/pair_amoeba.rst index 67c8e02557..c301caa332 100644 --- a/doc/src/pair_amoeba.rst +++ b/doc/src/pair_amoeba.rst @@ -33,100 +33,73 @@ Examples Additional info """"""""""""""" -doc:`Howto amoeba ` -doc:`bond_style amoeba ` -doc:`angle_style amoeba ` -doc:`dihedral_style amoeba ` -examples/amoeba -tools/amoeba -potentials/\*.prm.ameoba -potentials/\*.key.ameoba -potentials/\*.prm.hippo -potentials/\*.key.hippo +* doc:`Howto amoeba ` +* examples/amoeba +* tools/amoeba +* potentials/*.amoeba +* potentials/*.hippo Description """"""""""" -NOTE: edit this paragraph however you wish including adding or changing -citations (see bottom of this file) - The *amoeba* style computes the AMOEBA polarizeable field formulated -by Jay Ponder's group at U Washington at St Louis :ref:`(Ren) -`, :ref:`(Shi) `. The *hippo* style -computes the HIPPO polarizeable force field , an extension to AMOEBA, -formulated by Josh Rackers and collaborators in the Ponder group -:ref:`(Rackers) `. +by Jay Ponder's group at the U Washington at St Louis :ref:`(Ren) +`, :ref:`(Shi) `. The *hippo* style computes +the HIPPO polarizeable force field, an extension to AMOEBA, formulated +by Josh Rackers and collaborators in the Ponder group :ref:`(Rackers) +`. These force fields can be used when polarization effects are desired in simulations of water, organic molecules, and biomolecules including -proteins, provided that parameterizations (force field files) are -available for the systems you are interested in. Files in the LAMMPS -potentials with a "amoeba" or "hippo" suffix can be used. The Tinker -distribution and website may have other such files. +proteins, provided that parameterizations (Tinker PRM force field +files) are available for the systems you are interested in. Files in +the LAMMPS potentials directory with a "amoeba" or "hippo" suffix can +be used. The Tinker distribution and website have additional force +field files as well. -NOTE: replace these LaTeX formulas with a list of AMOEBA and HIPPO -terms in some simple notation. If desired, a more detailed -mathematical expression for each term could also be included below -the initial 2 formulas. - -The AMOEBA force field can be written as a collection of terms +As discussed on the doc:`Howto amoeba ` doc page, the +intermolecular (non-bonded) portion of the AMOEBA force field contains +these terms: .. math:: - E = 4 \epsilon \left[ \left(\frac{\sigma}{r}\right)^{12} - - \left(\frac{\sigma}{r}\right)^6 \right] - \qquad r < r_c + U_{amoeba} = U_{hal} + U_{multipole} + U_{polar} -:math:`r_c` is the cutoff, blah is the dipole, etc - -The HIPPO force field is similar but alters some of the terms +while the HIPPO force field contains these terms: .. math:: - E = 4 \epsilon \left[ \left(\frac{\sigma}{r}\right)^{12} - - \left(\frac{\sigma}{r}\right)^6 \right] - \qquad r < r_c + U_{hippo} = U_{repulsion} + U_{dispersion} + U_{multipole} + U_{polar} + U_{qxfer} -:math:`r_c` is the cutoff, blah is the dipole, etc +Conceptually, these terms compute the following interactions: + +* :math:`U_{hal}` = buffered 14-7 van der Waals with offsets applied to hydrogen atoms +* :math:`U_{repulsion}` = Pauli repulsion due to rearrangement of electron density +* :math:`U_{dispersion}` = dispersion between correlated, instantaneous induced dipole moments +* :math:`U_{multipole}` = electrostatics between permanent point charges, dipoles, and quadrupoles +* :math:`U_{polar}` = electronic polarization bewteen induced point dipoles +* :math:`U_{qxfer}` = charge transfer effects -NOTE: Add a sentence for each term to explain what physical effects -the FFs are encoding. E.g. The polar term iteratively computes an -induced dipole for each atom, then calculates dipole-dipole -interactions ... - -See the AMOEBA and HIPPO papers for further details. +Note that the AMOEBA versus HIPPO force fields typically compute the +same term differently using their own formulas. The references on +this doc page give full details for both force fields. .. note:: The AMOEBA and HIPPO force fields compute long-range charge, dipole, - and quadrupole interactions (NOTE: also long-range dispersion?). - However, unlike other models with long-range interactions in LAMMPS, - this does not require use of a KSpace style via the + and quadrupole interactions as well as long-range dispersion + effects. However, unlike other models with long-range interactions + in LAMMPS, this does not require use of a KSpace style via the :doc:`kspace_style ` command. That is because for AMOEBA and HIPPO the long-range computations are intertwined with - the pairwise compuations. So these pair style include both short- + the pairwise computations. So these pair style include both short- and long-range computations. This means the energy and virial computed by the pair style as well as the "Pair" timing reported by - LAMMPS will include the long-range components. - -.. note:: - - As explained on the :doc:`Howto amoeba ` doc page, use - of these pair styles to run a simulation with the AMOEBA or HIPPO - force fields requires your input script to use the :doc:`atom_style - hybrid full amoeba ` atom style, AMOEBA versions of - bond/angle/dihedral styles, the :doc:`special_bonds one/five - ` option, and the :doc:`fix property/atom one/five - ` command to define several additional per-atom - properties. The latter requires a "Tinker Types" section be - included in the LAMMPS data file. This can be auto-generated using - the tools/amoeba/tinker2lmp.py Python script. See the :doc:`Howto - amoeba ` doc page and tools/amoeba/README file for - details on using that tool. + LAMMPS will include the long-range calculations. The implementation of the AMOEBA and HIPPO force fields in LAMMPS was -done using code provided by the Ponder group from their `Tinker MD -code `_ written in F90. +done using F90 code provided by the Ponder group from their `Tinker MD +code `_. NOTE: what version of AMOEBA and HIPPO does LAMMPS implement? @@ -140,22 +113,22 @@ Only a single pair_coeff command is used with either the *amoeba* and pair_coeff * * ../potentials/protein.prm.amoeba ../potentials/protein.key.amoeba pair_coeff * * ../potentials/water.prm.hippo ../potentials/water.key.hippo -See examples of these files in the potentials directory. +Examples of the PRM files are in the potentials directory with an +*.amoeba or *.hippo suffix. The examples/amoeba directory has +examples of both PRM and KEY files. -The format of a PRM file is a collection of sections, each with -multiple lines. These are the sections which LAMMPS recognizes: +A Tinker PRM file composed of sections, each of which has multiple +lines. A Tinker KEY file is composed of lines, each of which has a keyword, +which can be followed by zero or more parameters. -NOTE: need to list these, possibly there are some LAMMPS skips - or which need to be removed for LAMMPS to use the PRM file? +The list of PRM sections and KEY keywords which LAMMPS recognizes are +listed on the doc:`Howto amoeba ` doc page. If not +recognized, the section or keyword is skipped. -The format of a KEY file is a series of lines, with one parameter and -its value per line. These are the parameters which LAMMPS recognizes: - -NOTE: need to list these, possibly there are some keywords LAMMPS skips - or which need to be removed for LAMMPS to use the KEY file? - -NOTE: Any other info about PRM and KEY files we should explain -for LAMMPS users here? +Note that if the KEY file is specified as NULL, then no file is +required; default values for various AMOEBA/HIPPO settings are used. +The doc:`Howto amoeba ` doc page also gives the default +settings. ---------- @@ -184,14 +157,38 @@ enabled if LAMMPS was built with that package. See the :doc:`Build package ` doc page for more info. The AMOEBA and HIPPO potential (PRM) and KEY files provided with -LAMMPS in the potentials directory are Tinker files parameterized for -Tinker units. Their numeric parameters are converted by LAMMPS to its -real units :doc:`units `. You can only use these pair styles -with real units. +LAMMPS in the potentials and examples/amoeva directories are Tinker +files parameterized for Tinker units. Their numeric parameters are +converted by LAMMPS to its real units :doc:`units `. Thus uou +can only use these pair styles with real units. These potentials do not yet calculate per-atom energy or virial contributions. +As explained on the :doc:`Howto amoeba ` doc page, use +of these pair styles to run a simulation with the AMOEBA or HIPPO +force fields requires several things. + +The first is a data file generated by the tools/tinker/tinker2lmp.py +conversion script which uses Tinker file force field file input to +create a data file compatible with LAMMPS. + +The second is use of these commands: + +* :doc:`atom_style amoeba ` +* :doc:`fix property/atom ` +* :doc:`special_bonds one/five ` + +And third, depending on the model being simulated, these +commands for intramolecular interactions may also be required: + +* :doc:`bond_style class2 ` +* :doc:`angle_style amoeba ` +* :doc:`dihedral_style fourier ` +* :doc:`improper_style amoeba ` +* :doc:`fix amoeba/pitorsion ` +* :doc:`fix amoeba/bitorsion ` + ---------- Related commands diff --git a/doc/src/special_bonds.rst b/doc/src/special_bonds.rst index 4b197fbf3a..8cb81c4cdb 100644 --- a/doc/src/special_bonds.rst +++ b/doc/src/special_bonds.rst @@ -11,7 +11,7 @@ Syntax special_bonds keyword values ... * one or more keyword/value pairs may be appended -* keyword = *amber* or *charmm* or *dreiding* or *fene* or *lj/coul* or *lj* or *coul* or *angle* or *dihedral* +* keyword = *amber* or *charmm* or *dreiding* or *fene* or *lj/coul* or *lj* or *coul* or *angle* or *dihedral* or *one/five* .. parsed-literal:: @@ -27,6 +27,7 @@ Syntax w1,w2,w3 = weights (0.0 to 1.0) on pairwise Coulombic interactions *angle* value = *yes* or *no* *dihedral* value = *yes* or *no* + *one/five* value = *yes* or *no* Examples """""""" @@ -45,10 +46,10 @@ Description Set weighting coefficients for pairwise energy and force contributions between pairs of atoms that are also permanently bonded to each other, either directly or via one or two intermediate bonds. These weighting -factors are used by nearly all :doc:`pair styles ` in LAMMPS -that compute simple pairwise interactions. Permanent bonds between -atoms are specified by defining the bond topology in the data file -read by the :doc:`read_data ` command. Typically a +factors are used by nearly all :doc:`pair styles ` in +LAMMPS that compute simple pairwise interactions. Permanent bonds +between atoms are specified by defining the bond topology in the data +file read by the :doc:`read_data ` command. Typically a :doc:`bond_style ` command is also used to define a bond potential. The rationale for using these weighting factors is that the interaction between a pair of bonded atoms is all (or mostly) @@ -58,31 +59,34 @@ atoms should be excluded (or reduced by a weighting factor). .. note:: - These weighting factors are NOT used by :doc:`pair styles ` that compute many-body interactions, since the - "bonds" that result from such interactions are not permanent, but are - created and broken dynamically as atom conformations change. Examples - of pair styles in this category are EAM, MEAM, Stillinger-Weber, - Tersoff, COMB, AIREBO, and ReaxFF. In fact, it generally makes no - sense to define permanent bonds between atoms that interact via these - potentials, though such bonds may exist elsewhere in your system, - e.g. when using the :doc:`pair_style hybrid ` command. - Thus LAMMPS ignores special_bonds settings when many-body potentials - are calculated. Please note, that the existence of explicit bonds - for atoms that are described by a many-body potential will alter the - neighbor list and thus can render the computation of those interactions - invalid, since those pairs are not only used to determine direct - pairwise interactions but also neighbors of neighbors and more. - The recommended course of action is to remove such bonds, or - if - that is not possible - use a special bonds setting of 1.0 1.0 1.0. + These weighting factors are NOT used by :doc:`pair styles + ` that compute many-body interactions, since the + "bonds" that result from such interactions are not permanent, but + are created and broken dynamically as atom conformations change. + Examples of pair styles in this category are EAM, MEAM, + Stillinger-Weber, Tersoff, COMB, AIREBO, and ReaxFF. In fact, it + generally makes no sense to define permanent bonds between atoms + that interact via these potentials, though such bonds may exist + elsewhere in your system, e.g. when using the :doc:`pair_style + hybrid ` command. Thus LAMMPS ignores special_bonds + settings when many-body potentials are calculated. Please note, + that the existence of explicit bonds for atoms that are described + by a many-body potential will alter the neighbor list and thus can + render the computation of those interactions invalid, since those + pairs are not only used to determine direct pairwise interactions + but also neighbors of neighbors and more. The recommended course + of action is to remove such bonds, or - if that is not possible - + use a special bonds setting of 1.0 1.0 1.0. .. note:: Unlike some commands in LAMMPS, you cannot use this command multiple times in an incremental fashion: e.g. to first set the LJ - settings and then the Coulombic ones. Each time you use this command - it sets all the coefficients to default values and only overrides the - one you specify, so you should set all the options you need each time - you use it. See more details at the bottom of this page. + settings and then the Coulombic ones. Each time you use this + command it sets all the coefficients to default values and only + overrides the one you specify, so you should set all the options + you need each time you use it. See more details at the bottom of + this page. The Coulomb factors are applied to any Coulomb (charge interaction) term that the potential calculates. The LJ factors are applied to the @@ -94,14 +98,14 @@ exclude it completely. The first of the 3 coefficients (LJ or Coulombic) is the weighting factor on 1-2 atom pairs, which are pairs of atoms directly bonded to -each other. The second coefficient is the weighting factor on 1-3 atom -pairs which are those separated by 2 bonds (e.g. the two H atoms in a -water molecule). The third coefficient is the weighting factor on 1-4 -atom pairs which are those separated by 3 bonds (e.g. the first and fourth -atoms in a dihedral interaction). Thus if the 1-2 coefficient is set -to 0.0, then the pairwise interaction is effectively turned off for -all pairs of atoms bonded to each other. If it is set to 1.0, then -that interaction will be at full strength. +each other. The second coefficient is the weighting factor on 1-3 +atom pairs which are those separated by 2 bonds (e.g. the two H atoms +in a water molecule). The third coefficient is the weighting factor +on 1-4 atom pairs which are those separated by 3 bonds (e.g. the first +and fourth atoms in a dihedral interaction). Thus if the 1-2 +coefficient is set to 0.0, then the pairwise interaction is +effectively turned off for all pairs of atoms bonded to each other. +If it is set to 1.0, then that interaction will be at full strength. .. note:: @@ -184,21 +188,27 @@ interaction between atoms 2 and 5 will be unaffected (full weighting of 1.0). If the *dihedral* keyword is specified as *no* which is the default, then the 2,5 interaction will also be weighted by 0.5. +The *one/five* keyword enable calculation and storage of a list of 1-5 +neighbors in the molecular topology for each atom. It is required by +some pair styles, such as :doc:`pair_style amoeba ` and +:doc:`pair_style hippo `. + ---------- .. note:: LAMMPS stores and maintains a data structure with a list of the - first, second, and third neighbors of each atom (within the bond topology of - the system). If new bonds are created (or molecules added containing - atoms with more special neighbors), the size of this list needs to - grow. Note that adding a single bond always adds a new first neighbor - but may also induce \*many\* new second and third neighbors, depending on the - molecular topology of your system. Using the *extra/special/per/atom* - keyword to either :doc:`read_data ` or :doc:`create_box ` - reserves empty space in the list for this N additional first, second, or third - neighbors to be added. If you do not do this, you may get an error - when bonds (or molecules) are added. + first, second, and third neighbors of each atom (within the bond + topology of the system). If new bonds are created (or molecules + added containing atoms with more special neighbors), the size of + this list needs to grow. Note that adding a single bond always + adds a new first neighbor but may also induce \*many\* new second + and third neighbors, depending on the molecular topology of your + system. Using the *extra/special/per/atom* keyword to either + :doc:`read_data ` or :doc:`create_box ` + reserves empty space in the list for this N additional first, + second, or third neighbors to be added. If you do not do this, you + may get an error when bonds (or molecules) are added. ---------- @@ -226,16 +236,16 @@ In the first case you end up with (after the second command): LJ: 0.0 0.0 0.0 Coul: 0.0 0.0 1.0 -while only in the second case, you get the desired settings of: +while only in the second case do you get the desired settings of: .. parsed-literal:: LJ: 0.0 1.0 1.0 Coul: 0.0 0.0 1.0 -This happens because the LJ (and Coul) settings are reset to -their default values before modifying them, each time the -*special_bonds* command is issued. +This happens because the LJ (and Coul) settings are reset to their +default values before modifying them, each time the *special_bonds* +command is issued. Restrictions """""""""""" diff --git a/src/AMOEBA/amoeba_file.cpp b/src/AMOEBA/amoeba_file.cpp index 2469c08f43..f67eacd879 100644 --- a/src/AMOEBA/amoeba_file.cpp +++ b/src/AMOEBA/amoeba_file.cpp @@ -493,9 +493,6 @@ void PairAmoeba::read_keyfile(char *filename) } else if (strcmp(keyword,"pcg-peek") == 0) { if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); pcgpeek = utils::numeric(FLERR,words[1],true,lmp); - } else if (strcmp(keyword,"usolve-diag") == 0) { - if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); - udiag = utils::numeric(FLERR,words[1],true,lmp); } else {} diff --git a/src/AMOEBA/pair_amoeba.cpp b/src/AMOEBA/pair_amoeba.cpp index 4288de6e36..ebf4a19bc6 100644 --- a/src/AMOEBA/pair_amoeba.cpp +++ b/src/AMOEBA/pair_amoeba.cpp @@ -620,14 +620,6 @@ void PairAmoeba::coeff(int narg, char **arg) if (narg == 3) read_keyfile(NULL); else read_keyfile(arg[3]); - // required for now, until 1-5 settings are implemented in LAMMPS - - //if (special_hal[4] != 1.0 || special_repel[4] != 1.0 || - // special_disp[4] != 1.0 || special_mpole[4] != 1.0 || - // special_polar_pscale[4] != 1.0 || special_polar_piscale[4] != 1.0 || - // special_polar_wscale[4] != 1.0) - // error->all(FLERR,"AMOEBA 1-5 weights must be 1.0 for now"); - // compute Vdwl mixing rules, only for AMOEBA if (amoeba) { From 353ebb11f10efaf511cc57e01540be06ac6c553f Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Mon, 18 Apr 2022 16:52:34 -0600 Subject: [PATCH 121/585] add README for tinker2lmp.py --- tools/tinker/README | 26 ++++++++++++++++++++++++++ 1 file changed, 26 insertions(+) create mode 100644 tools/tinker/README diff --git a/tools/tinker/README b/tools/tinker/README new file mode 100644 index 0000000000..04ee066642 --- /dev/null +++ b/tools/tinker/README @@ -0,0 +1,26 @@ +Examples of how this tool created the data files in the +examples/amoeba directory: + +** water_dimer: + +% python tinker2lmp.py -xyz water_dimer.xyz -amoeba amoeba_water.prm -data data.water_dimer.amoeba + +% python tinker2lmp.py -xyz water_dimer.xyz -hippo hippo_water.prm -data data.water_dimer.hippo + +** water_hexamer: + +% python tinker2lmp.py -xyz water_hexamer.xyz -amoeba amoeba_water.prm -data data.water_hexamer.amoeba + +% python tinker2lmp.py -xyz water_hexamer.xyz -hippo hippo_water.prm -data data.water_hexamer.hippo + +** water_box: + +% python tinker2lmp.py -xyz water_box.xyz -amoeba amoeba_water.prm -data data.water_box.amoeba -pbc 18.643 18.643 18.643 + +% python tinker2lmp.py -xyz water_box.xyz -hippo hippo_water.prm -data data.water_box.hippo -pbc 18.643 18.643 18.643 + +** ubiquitin: + +% python tinker2lmp.py -xyz ubiquitin.xyz -amoeba amoeba_ubiquitin.prm -data data.ubiquitin.new -pbc 54.99 41.91 41.91 -bitorsion bitorsion.ubiquitin.data.new + + From 409c38ece17110ee5319a8f40c7978724dd56706 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Mon, 18 Apr 2022 17:31:12 -0600 Subject: [PATCH 122/585] missed one change --- src/gridcomm.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/gridcomm.cpp b/src/gridcomm.cpp index 21d68923a9..d3476665be 100644 --- a/src/gridcomm.cpp +++ b/src/gridcomm.cpp @@ -1074,7 +1074,7 @@ reverse_comm_regular(T *ptr, int nper, int /*nbyte*/, int which, if (swap[m].npack) MPI_Wait(&request,MPI_STATUS_IGNORE); } - caller->unpack_reverse_grid(which,buf2,swap[m].npack,swap[m].packlist); + ptr->unpack_reverse_grid(which,buf2,swap[m].npack,swap[m].packlist); } } From d3b70c7d5da05bfb8214d94187ad629010b45a7a Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Mon, 18 Apr 2022 17:52:18 -0600 Subject: [PATCH 123/585] more changes to sync with new templated GridComm --- src/AMOEBA/amoeba_convolution.cpp | 8 ++++---- src/AMOEBA/amoeba_induce.cpp | 22 +++++++++++----------- src/AMOEBA/amoeba_multipole.cpp | 2 +- src/AMOEBA/amoeba_polar.cpp | 2 +- src/AMOEBA/amoeba_repulsion.cpp | 2 +- src/gridcomm.cpp | 12 ++++++++++++ src/gridcomm.h | 2 +- 7 files changed, 31 insertions(+), 19 deletions(-) diff --git a/src/AMOEBA/amoeba_convolution.cpp b/src/AMOEBA/amoeba_convolution.cpp index db71e6009a..fb1f7ce47c 100644 --- a/src/AMOEBA/amoeba_convolution.cpp +++ b/src/AMOEBA/amoeba_convolution.cpp @@ -326,7 +326,7 @@ FFT_SCALAR *AmoebaConvolution::pre_convolution_3d() if (DEBUG) debug_scalar(GRIDBRICK_OUT,"PRE Convo / PRE GridComm"); - gc->reverse_comm(amoeba,1,sizeof(FFT_SCALAR),which, + gc->reverse_comm(GridComm::PAIR,amoeba,1,sizeof(FFT_SCALAR),which, gc_buf1,gc_buf2,MPI_FFT_SCALAR); if (DEBUG) debug_scalar(GRIDBRICK_IN,"PRE Convo / POST GridComm"); @@ -382,7 +382,7 @@ FFT_SCALAR *AmoebaConvolution::pre_convolution_4d() if (DEBUG) debug_scalar(GRIDBRICK_OUT,"PRE Convo / PRE GridComm"); - gc->reverse_comm(amoeba,2,sizeof(FFT_SCALAR),which, + gc->reverse_comm(GridComm::PAIR,amoeba,2,sizeof(FFT_SCALAR),which, gc_buf1,gc_buf2,MPI_FFT_SCALAR); if (DEBUG) debug_scalar(GRIDBRICK_IN,"PRE Convo / POST GridComm"); @@ -466,7 +466,7 @@ void *AmoebaConvolution::post_convolution_3d() if (DEBUG) debug_scalar(GRIDBRICK_IN,"POST Convo / PRE gridcomm"); if (DEBUG) debug_file(GRIDBRICK_IN,"post.convo.pre.gridcomm"); - gc->forward_comm(amoeba,1,sizeof(FFT_SCALAR),which, + gc->forward_comm(GridComm::PAIR,amoeba,1,sizeof(FFT_SCALAR),which, gc_buf1,gc_buf2,MPI_FFT_SCALAR); return (void *) grid_brick; @@ -505,7 +505,7 @@ void *AmoebaConvolution::post_convolution_4d() if (DEBUG) debug_scalar(GRIDBRICK_IN,"POST Convo / PRE gridcomm"); if (DEBUG) debug_file(GRIDBRICK_IN,"post.convo.pre.gridcomm"); - gc->forward_comm(amoeba,2,sizeof(FFT_SCALAR),which, + gc->forward_comm(GridComm::PAIR,amoeba,2,sizeof(FFT_SCALAR),which, gc_buf1,gc_buf2,MPI_FFT_SCALAR); return (void *) cgrid_brick; diff --git a/src/AMOEBA/amoeba_induce.cpp b/src/AMOEBA/amoeba_induce.cpp index e644f7759a..312d71b3a8 100644 --- a/src/AMOEBA/amoeba_induce.cpp +++ b/src/AMOEBA/amoeba_induce.cpp @@ -111,7 +111,7 @@ void PairAmoeba::induce() // reverse comm to sum field,fieldp from ghost atoms to owned atoms crstyle = FIELD; - comm->reverse_comm_pair(this); + comm->reverse_comm(this); // DEBUG statements @@ -166,12 +166,12 @@ void PairAmoeba::induce() optlevel = m - 1; // used in umutual1() for fopt,foptp cfstyle = INDUCE; - comm->forward_comm_pair(this); + comm->forward_comm(this); ufield0c(field,fieldp); crstyle = FIELD; - comm->reverse_comm_pair(this); + comm->reverse_comm(this); for (i = 0; i < nlocal; i++) { itype = amtype[i]; @@ -251,12 +251,12 @@ void PairAmoeba::induce() // get the electrostatic field due to induced dipoles cfstyle = INDUCE; - comm->forward_comm_pair(this); + comm->forward_comm(this); ufield0c(field,fieldp); crstyle = FIELD; - comm->reverse_comm_pair(this); + comm->reverse_comm(this); // DEBUG statements @@ -293,11 +293,11 @@ void PairAmoeba::induce() if (pcgprec) { cfstyle = RSD; - comm->forward_comm_pair(this); + comm->forward_comm(this); uscale0b(BUILD,rsd,rsdp,zrsd,zrsdp); uscale0b(APPLY,rsd,rsdp,zrsd,zrsdp); crstyle = ZRSD; - comm->reverse_comm_pair(this); + comm->reverse_comm(this); } for (i = 0; i < nlocal; i++) { @@ -336,14 +336,14 @@ void PairAmoeba::induce() } cfstyle = INDUCE; - comm->forward_comm_pair(this); + comm->forward_comm(this); ufield0c(field,fieldp); //error->all(FLERR,"STOP"); crstyle = FIELD; - comm->reverse_comm_pair(this); + comm->reverse_comm(this); // DEBUG statements @@ -418,10 +418,10 @@ void PairAmoeba::induce() if (pcgprec) { cfstyle = RSD; - comm->forward_comm_pair(this); + comm->forward_comm(this); uscale0b(APPLY,rsd,rsdp,zrsd,zrsdp); crstyle = ZRSD; - comm->reverse_comm_pair(this); + comm->reverse_comm(this); } // DEBUG statements diff --git a/src/AMOEBA/amoeba_multipole.cpp b/src/AMOEBA/amoeba_multipole.cpp index 748a1e799f..a2c3a41231 100644 --- a/src/AMOEBA/amoeba_multipole.cpp +++ b/src/AMOEBA/amoeba_multipole.cpp @@ -553,7 +553,7 @@ void PairAmoeba::multipole_real() // reverse comm to sum torque from ghost atoms to owned atoms crstyle = TORQUE; - comm->reverse_comm_pair(this); + comm->reverse_comm(this); // resolve site torques then increment forces and virial diff --git a/src/AMOEBA/amoeba_polar.cpp b/src/AMOEBA/amoeba_polar.cpp index 9c54852591..cf62599a23 100644 --- a/src/AMOEBA/amoeba_polar.cpp +++ b/src/AMOEBA/amoeba_polar.cpp @@ -1175,7 +1175,7 @@ void PairAmoeba::polar_real() // reverse comm to sum ufld,dufld from ghost atoms to owned atoms crstyle = UFLD; - comm->reverse_comm_pair(this); + comm->reverse_comm(this); // torque is induced field and gradient cross permanent moments diff --git a/src/AMOEBA/amoeba_repulsion.cpp b/src/AMOEBA/amoeba_repulsion.cpp index 0342eeb513..e477941b5c 100644 --- a/src/AMOEBA/amoeba_repulsion.cpp +++ b/src/AMOEBA/amoeba_repulsion.cpp @@ -383,7 +383,7 @@ void PairAmoeba::repulsion() // reverse comm to sum torque from ghost atoms to owned atoms crstyle = TORQUE; - comm->reverse_comm_pair(this); + comm->reverse_comm(this); // resolve site torques then increment forces and virial diff --git a/src/gridcomm.cpp b/src/gridcomm.cpp index d3476665be..fc53026cc8 100644 --- a/src/gridcomm.cpp +++ b/src/gridcomm.cpp @@ -936,6 +936,9 @@ void GridComm::forward_comm(int caller, void *ptr, int nper, int nbyte, int whic if (caller == KSPACE) forward_comm_regular((KSpace *) ptr,nper,nbyte,which, buf1,buf2,datatype); + else if (caller == PAIR) + forward_comm_regular((Pair *) ptr,nper,nbyte,which, + buf1,buf2,datatype); else if (caller == FIX) forward_comm_regular((Fix *) ptr,nper,nbyte,which, buf1,buf2,datatype); @@ -943,6 +946,9 @@ void GridComm::forward_comm(int caller, void *ptr, int nper, int nbyte, int whic if (caller == KSPACE) forward_comm_tiled((KSpace *) ptr,nper,nbyte,which, buf1,buf2,datatype); + else if (caller == PAIR) + forward_comm_tiled((Pair *) ptr,nper,nbyte,which, + buf1,buf2,datatype); else if (caller == FIX) forward_comm_tiled((Fix *) ptr,nper,nbyte, which,buf1,buf2,datatype); @@ -1035,6 +1041,9 @@ void GridComm::reverse_comm(int caller, void *ptr, int nper, int nbyte, int whic if (caller == KSPACE) reverse_comm_regular((KSpace *) ptr,nper,nbyte,which, buf1,buf2,datatype); + else if (caller == PAIR) + reverse_comm_regular((Pair *) ptr,nper,nbyte,which, + buf1,buf2,datatype); else if (caller == FIX) reverse_comm_regular((Fix *) ptr,nper,nbyte,which, buf1,buf2,datatype); @@ -1042,6 +1051,9 @@ void GridComm::reverse_comm(int caller, void *ptr, int nper, int nbyte, int whic if (caller == KSPACE) reverse_comm_tiled((KSpace *) ptr,nper,nbyte,which, buf1,buf2,datatype); + else if (caller == PAIR) + reverse_comm_tiled((Pair *) ptr,nper,nbyte,which, + buf1,buf2,datatype); else if (caller == FIX) reverse_comm_tiled((Fix *) ptr,nper,nbyte,which, buf1,buf2,datatype); diff --git a/src/gridcomm.h b/src/gridcomm.h index dec43a789a..011faad9fb 100644 --- a/src/gridcomm.h +++ b/src/gridcomm.h @@ -20,7 +20,7 @@ namespace LAMMPS_NS { class GridComm : protected Pointers { public: - enum { KSPACE = 0, FIX = 1 }; // calling classes + enum { KSPACE = 0, PAIR = 1, FIX = 2 }; // calling classes GridComm(class LAMMPS *, MPI_Comm, int, int, int, int, int, int, int, int, int, int, int, int, int, int, int); From 0a9106a81cf6d2ad6be5ed9227158641e285beb2 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Mon, 18 Apr 2022 17:54:32 -0600 Subject: [PATCH 124/585] final sync with current develop --- examples/amoeba/in.ubiquitin | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/examples/amoeba/in.ubiquitin b/examples/amoeba/in.ubiquitin index 8abcac750f..9f3fefba73 100644 --- a/examples/amoeba/in.ubiquitin +++ b/examples/amoeba/in.ubiquitin @@ -29,7 +29,7 @@ read_data data.ubiquitin fix amtype NULL "Tinker Types" & fix pit pitorsions PiTorsions & fix bit bitorsions BiTorsions -pair_style amoeba include improper +pair_style amoeba pair_coeff * * amoeba_ubiquitin.prm amoeba_ubiquitin.key special_bonds lj/coul 0.5 0.5 0.5 one/five yes From 25b0454505193e0b6294d12052c33e6551999f3c Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 18 Apr 2022 21:19:30 -0400 Subject: [PATCH 125/585] fix various issues for building the manual cleanly: latex, links, escapes, formatting --- doc/src/Howto_amoeba.rst | 18 +++++++++--------- doc/src/Packages_details.rst | 19 +++++++++++++++++++ doc/src/Packages_list.rst | 5 +++++ doc/src/angle_amoeba.rst | 8 ++++---- doc/src/fix_amoeba_bitorsion.rst | 2 +- doc/src/fix_amoeba_pitorsion.rst | 2 +- doc/src/pair_amoeba.rst | 29 +++++++++++++++++------------ doc/src/pair_style.rst | 2 ++ 8 files changed, 58 insertions(+), 27 deletions(-) diff --git a/doc/src/Howto_amoeba.rst b/doc/src/Howto_amoeba.rst index 6615e319a6..126beb0ce5 100644 --- a/doc/src/Howto_amoeba.rst +++ b/doc/src/Howto_amoeba.rst @@ -34,9 +34,9 @@ details for HIPPO are in this paper: :ref:`(Rackers) .. math:: - U & = U_{intermolecular} + U_{intramolecular) \\ - U_{intermolecular} & = U_{hal} + U_{repulsion} + U_{dispersion} + U_{multipole} + U_{polar} + U_{qxfer} \\ - U_{intramolecular} & = U_{bond} + U_{angle} + U_{torsion} + U_{oop} + U_{b\theta} + U_{Urey-Bradley} + U_{pitorsion} + U_{bitorsion} + U & = U_{intermolecular} + U_{intramolecular} \\ + U_{intermolecular} & = U_{hal} + U_{repulsion} + U_{dispersion} + U_{multipole} + U_{polar} + U_{qxfer} \\ + U_{intramolecular} & = U_{bond} + U_{angle} + U_{torsion} + U_{oop} + U_{b\theta} + U_{Urey-Bradley} + U_{pitorsion} + U_{bitorsion} For intermolecular terms, the AMOEBA force field includes only the :math:`U_{hal}`, :math:`U_{multipole}`, :math:`U_{polar}` terms. The @@ -55,12 +55,12 @@ The :doc:`angle_style amoeba ` command includes the atoms in the angle. The :math:`U_{pitorsion}` term is computed by the :doc:`fix -amoeba/pitorsion ` command. It computes 6-body +amoeba/pitorsion ` command. It computes 6-body interaction between a pair of bonded atoms which each have 2 additional bond partners. The :math:`U_{bitorsion}` term is computed by the :doc:`fix -amoeba/bitorsion ` command. It computes 5-body +amoeba/bitorsion ` command. It computes 5-body interaction between two 4-body torsions (dihedrals) which overlap, having 3 atoms in common. @@ -72,8 +72,8 @@ compute: * :doc:`angle_style amoeba ` * :doc:`dihedral_style fourier ` * :doc:`improper_style amoeba ` -* :doc:`fix amoeba/pitorsion ` -* :doc:`fix amoeba/bitorsion ` +* :doc:`fix amoeba/pitorsion ` +* :doc:`fix amoeba/bitorsion ` ---------- @@ -127,7 +127,7 @@ In the example above the fix ID is amtype. Similarly, if the system you are simulating defines AMOEBA/HIPPO pitorsion or bitorsion interactions, there will be entries in the data file for those interactions. They require a :doc:`fix -amoeba/pitortion ` and :doc:`fix +amoeba/pitortion ` and :doc:`fix amoeba/bitorsion ` command be defined. In the example above, the IDs for these two fixes are "pit" and "bit". @@ -263,7 +263,7 @@ Switches and their arguments may be specified in any order. The -xyz switch is required and specifies an input XYZ file as an argument. The format of this file is an extended XYZ format used by -Tinker for its input. Example *.xyz files are in the examples/amoeba +Tinker for its input. Example \*.xyz files are in the examples/amoeba directory. The file lists the atoms in the system. Each atom has the following information: Tinker species name (ignored by LAMMPS), xyz coordinates, Tinker numeric type, and a list of atom IDs the atom is diff --git a/doc/src/Packages_details.rst b/doc/src/Packages_details.rst index 6d2b2f5a68..b2fd6d8020 100644 --- a/doc/src/Packages_details.rst +++ b/doc/src/Packages_details.rst @@ -27,6 +27,7 @@ page gives those details. :columns: 6 * :ref:`ADIOS ` + * :ref:`AMOEBA ` * :ref:`ASPHERE ` * :ref:`ATC ` * :ref:`AWPMD ` @@ -148,6 +149,24 @@ This package has :ref:`specific installation instructions ` on the :doc:` ---------- +.. _PKG-AMOEBA: + +AMOEBA package +--------------- + +**Contents:** + +TODO + +**Supporting info:** + +* src/AMOEBA: filenames -> commands +* :doc:`AMOEBA and HIPPO howto ` +* examples/amoeba +* TODO + +---------- + .. _PKG-ASPHERE: ASPHERE package diff --git a/doc/src/Packages_list.rst b/doc/src/Packages_list.rst index 14d76e0ba3..c8e8edfa4d 100644 --- a/doc/src/Packages_list.rst +++ b/doc/src/Packages_list.rst @@ -33,6 +33,11 @@ whether an extra library is needed to build and use the package: - :doc:`dump adios ` - PACKAGES/adios - ext + * - :ref:`AMOEBA ` + - AMOEBA and HIPPO force fields + - :doc:`AMOEBA and HIPPO howto ` + - amoeba + - no * - :ref:`ASPHERE ` - aspherical particle models - :doc:`Howto spherical ` diff --git a/doc/src/angle_amoeba.rst b/doc/src/angle_amoeba.rst index 9a20299f45..4eee185991 100644 --- a/doc/src/angle_amoeba.rst +++ b/doc/src/angle_amoeba.rst @@ -29,9 +29,9 @@ The *amoeba* angle style uses the potential .. math:: E & = E_a + E_{ba} + E_{ub} \\ - E_a = K_2\left(\theta - \theta_0\right)^2 + K_3\left(\theta - \theta_0\right)^3 + K_4\left(\theta - \theta_0\right)^4 + K_5\left(\theta - \theta_0\right)^5 + K_6\left(\theta - \theta_0\right)^6 - E_{ba} & = N_1 (r_{ij} - r_1) (\theta - \theta_0) + N_2(r_{jk} - r_2)(\theta - \theta_0) - E_{ub} & = K_{ub} (r_{ik} - r_{ub})^2) + E_a & = K_2\left(\theta - \theta_0\right)^2 + K_3\left(\theta - \theta_0\right)^3 + K_4\left(\theta - \theta_0\right)^4 + K_5\left(\theta - \theta_0\right)^5 + K_6\left(\theta - \theta_0\right)^6 \\ + E_{ba} & = N_1 (r_{ij} - r_1) (\theta - \theta_0) + N_2(r_{jk} - r_2)(\theta - \theta_0) \\ + E_{ub} & = K_{ub} (r_{ik} - r_{ub})^2 where :math:`E_a` is the angle term, :math:`E_{ba}` is a bond-angle term, ::math:`E_{ub}` is a Urey-Bradley bond term, :math:`\theta_0` is @@ -45,7 +45,7 @@ doc:`Howto amoeba ` doc page for more information about the implemention of AMOEBA and HIPPO in LAMMPS. Note that the :math:`E_a` and :math:`E_{ba}` formulas are identical to -those used for the :doc:`angle_style class2/p6 ` +those used for the :doc:`angle_style class2/p6 ` command, however there is no bond-bond cross term formula for :math:`E_{bb}`. Additionally, there is a :math:`E_{ub}` term for a Urey-Bradley bond. It is effectively a harmonic bond between the I diff --git a/doc/src/fix_amoeba_bitorsion.rst b/doc/src/fix_amoeba_bitorsion.rst index b05c2128d6..42f87d7fa4 100644 --- a/doc/src/fix_amoeba_bitorsion.rst +++ b/doc/src/fix_amoeba_bitorsion.rst @@ -1,7 +1,7 @@ .. index:: fix amoeba/bitorsion fix amoeba/bitorsion command -================ +============================ Syntax """""" diff --git a/doc/src/fix_amoeba_pitorsion.rst b/doc/src/fix_amoeba_pitorsion.rst index b80ca3a285..8b724229f1 100644 --- a/doc/src/fix_amoeba_pitorsion.rst +++ b/doc/src/fix_amoeba_pitorsion.rst @@ -1,7 +1,7 @@ .. index:: fix amoeba/pitorsion fix amoeba/pitorsion command -================ +============================ Syntax """""" diff --git a/doc/src/pair_amoeba.rst b/doc/src/pair_amoeba.rst index c301caa332..5274bd4658 100644 --- a/doc/src/pair_amoeba.rst +++ b/doc/src/pair_amoeba.rst @@ -5,7 +5,7 @@ pair_style amoeba command ========================= pair_style hippo command -========================= +======================== Syntax """""" @@ -36,8 +36,8 @@ Additional info * doc:`Howto amoeba ` * examples/amoeba * tools/amoeba -* potentials/*.amoeba -* potentials/*.hippo +* potentials/\*.amoeba +* potentials/\*.hippo Description """"""""""" @@ -114,7 +114,7 @@ Only a single pair_coeff command is used with either the *amoeba* and pair_coeff * * ../potentials/water.prm.hippo ../potentials/water.key.hippo Examples of the PRM files are in the potentials directory with an -*.amoeba or *.hippo suffix. The examples/amoeba directory has +\*.amoeba or \*.hippo suffix. The examples/amoeba directory has examples of both PRM and KEY files. A Tinker PRM file composed of sections, each of which has multiple @@ -165,8 +165,8 @@ can only use these pair styles with real units. These potentials do not yet calculate per-atom energy or virial contributions. -As explained on the :doc:`Howto amoeba ` doc page, use -of these pair styles to run a simulation with the AMOEBA or HIPPO +As explained on the :doc:`AMOEBA and HIPPO howto ` page, +use of these pair styles to run a simulation with the AMOEBA or HIPPO force fields requires several things. The first is a data file generated by the tools/tinker/tinker2lmp.py @@ -186,18 +186,23 @@ commands for intramolecular interactions may also be required: * :doc:`angle_style amoeba ` * :doc:`dihedral_style fourier ` * :doc:`improper_style amoeba ` -* :doc:`fix amoeba/pitorsion ` -* :doc:`fix amoeba/bitorsion ` +* :doc:`fix amoeba/pitorsion ` +* :doc:`fix amoeba/bitorsion ` ---------- Related commands """""""""""""""" -:doc:`atom_style amoeba `, `bond_style amoeba -:doc:`, `angle_style amoeba `, -:doc:`dihedral_style amoeba `, `special_bonds -:doc:one/five ` +:doc:`atom_style amoeba `, +:doc:`bond_style class2 `, +:doc:`angle_style amoeba `, +:doc:`dihedral_style fourier `, +:doc:`improper_style amoeba `, +:doc:`fix amoeba/pitorsion `, +:doc:`fix amoeba/bitorsion `, +:doc:`special_bonds one/five `, +:doc:`fix property/atom ` Default """"""" diff --git a/doc/src/pair_style.rst b/doc/src/pair_style.rst index b42e3c9a50..8215c091ce 100644 --- a/doc/src/pair_style.rst +++ b/doc/src/pair_style.rst @@ -116,6 +116,7 @@ accelerated styles exist. * :doc:`agni ` - AGNI machine-learning potential * :doc:`airebo ` - AIREBO potential of Stuart * :doc:`airebo/morse ` - AIREBO with Morse instead of LJ +* :doc:`amoeba ` - * :doc:`atm ` - Axilrod-Teller-Muto potential * :doc:`awpmd/cut ` - Antisymmetrized Wave Packet MD potential for atoms and electrons * :doc:`beck ` - Beck potential @@ -202,6 +203,7 @@ accelerated styles exist. * :doc:`hbond/dreiding/lj ` - DREIDING hydrogen bonding LJ potential * :doc:`hbond/dreiding/morse ` - DREIDING hydrogen bonding Morse potential * :doc:`hdnnp ` - High-dimensional neural network potential +* :doc:`hippo ` - * :doc:`ilp/graphene/hbn ` - registry-dependent interlayer potential (ILP) * :doc:`ilp/tmd ` - interlayer potential (ILP) potential for transition metal dichalcogenides (TMD) * :doc:`kim ` - interface to potentials provided by KIM project From 89195363d63a3444e1bdf20deba2b18dec37c138 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 18 Apr 2022 21:20:13 -0400 Subject: [PATCH 126/585] whitespace --- doc/src/Howto_amoeba.rst | 4 +- doc/src/fix_amoeba_pitorsion.rst | 2 +- doc/src/pair_amoeba.rst | 4 +- doc/src/pair_style.rst | 4 +- src/AMOEBA/amoeba_charge_transfer.cpp | 4 +- src/AMOEBA/amoeba_convolution.cpp | 260 +++++++------- src/AMOEBA/amoeba_convolution.h | 12 +- src/AMOEBA/amoeba_dispersion.cpp | 96 ++--- src/AMOEBA/amoeba_file.cpp | 134 +++---- src/AMOEBA/amoeba_hal.cpp | 14 +- src/AMOEBA/amoeba_induce.cpp | 422 +++++++++++----------- src/AMOEBA/amoeba_kspace.cpp | 370 +++++++++---------- src/AMOEBA/amoeba_multipole.cpp | 256 ++++++------- src/AMOEBA/amoeba_polar.cpp | 498 +++++++++++++------------- src/AMOEBA/amoeba_repulsion.cpp | 112 +++--- src/AMOEBA/amoeba_utils.cpp | 224 ++++++------ src/AMOEBA/angle_amoeba.cpp | 42 +-- src/AMOEBA/atom_vec_amoeba.cpp | 2 +- src/AMOEBA/fix_amoeba_bitorsion.cpp | 76 ++-- src/AMOEBA/fix_amoeba_bitorsion.h | 4 +- src/AMOEBA/fix_amoeba_pitorsion.cpp | 24 +- src/AMOEBA/improper_amoeba.cpp | 12 +- src/AMOEBA/pair_amoeba.cpp | 320 ++++++++--------- src/AMOEBA/pair_amoeba.h | 48 +-- src/angle.cpp | 2 +- src/atom.cpp | 4 +- src/atom.h | 2 +- src/fix_property_atom.cpp | 8 +- src/fix_store.cpp | 4 +- src/force.cpp | 8 +- src/force.h | 2 +- src/memory.h | 14 +- src/modify.cpp | 2 +- src/pair.h | 4 +- src/special.cpp | 44 +-- 35 files changed, 1519 insertions(+), 1519 deletions(-) diff --git a/doc/src/Howto_amoeba.rst b/doc/src/Howto_amoeba.rst index 126beb0ce5..8e1d6635be 100644 --- a/doc/src/Howto_amoeba.rst +++ b/doc/src/Howto_amoeba.rst @@ -94,14 +94,14 @@ and HIPPO. improper_style amoeba # required per-atom data fix amtype all property/atom i_amtype ghost yes - fix extra all property/atom & + fix extra all property/atom & i_amgroup i_ired i_xaxis i_yaxis i_zaxis d_pval ghost yes fix polaxe all property/atom i_polaxe fix pit all amoeba/pitorsion # PiTorsion terms in FF fix_modify pit energy yes # Bitorsion terms in FF - fix bit all amoeba/bitorsion bitorsion.ubiquitin.data + fix bit all amoeba/bitorsion bitorsion.ubiquitin.data fix_modify bit energy yes read_data data.ubiquitin fix amtype NULL "Tinker Types" & diff --git a/doc/src/fix_amoeba_pitorsion.rst b/doc/src/fix_amoeba_pitorsion.rst index 8b724229f1..7d9baac0e1 100644 --- a/doc/src/fix_amoeba_pitorsion.rst +++ b/doc/src/fix_amoeba_pitorsion.rst @@ -88,7 +88,7 @@ the pitorsion 5-atom tuples; it is ignored by LAMMPS. The second column is the "type" of the interaction; it is an index into the PiTorsion Coeffs. The remaining 5 columns are the atom IDs of the atoms in the two 4-atom dihedrals that overlap to create the pitorsion -5-body interaction. +5-body interaction. Note that the "pitorsion types" and "pitorsions" and "PiTorsion Coeffs" and "PiTorsions" keywords for the header and body sections diff --git a/doc/src/pair_amoeba.rst b/doc/src/pair_amoeba.rst index 5274bd4658..7cfc8ddea1 100644 --- a/doc/src/pair_amoeba.rst +++ b/doc/src/pair_amoeba.rst @@ -72,7 +72,7 @@ while the HIPPO force field contains these terms: U_{hippo} = U_{repulsion} + U_{dispersion} + U_{multipole} + U_{polar} + U_{qxfer} Conceptually, these terms compute the following interactions: - + * :math:`U_{hal}` = buffered 14-7 van der Waals with offsets applied to hydrogen atoms * :math:`U_{repulsion}` = Pauli repulsion due to rearrangement of electron density * :math:`U_{dispersion}` = dispersion between correlated, instantaneous induced dipole moments @@ -119,7 +119,7 @@ examples of both PRM and KEY files. A Tinker PRM file composed of sections, each of which has multiple lines. A Tinker KEY file is composed of lines, each of which has a keyword, -which can be followed by zero or more parameters. +which can be followed by zero or more parameters. The list of PRM sections and KEY keywords which LAMMPS recognizes are listed on the doc:`Howto amoeba ` doc page. If not diff --git a/doc/src/pair_style.rst b/doc/src/pair_style.rst index 8215c091ce..355f3c4928 100644 --- a/doc/src/pair_style.rst +++ b/doc/src/pair_style.rst @@ -116,7 +116,7 @@ accelerated styles exist. * :doc:`agni ` - AGNI machine-learning potential * :doc:`airebo ` - AIREBO potential of Stuart * :doc:`airebo/morse ` - AIREBO with Morse instead of LJ -* :doc:`amoeba ` - +* :doc:`amoeba ` - * :doc:`atm ` - Axilrod-Teller-Muto potential * :doc:`awpmd/cut ` - Antisymmetrized Wave Packet MD potential for atoms and electrons * :doc:`beck ` - Beck potential @@ -203,7 +203,7 @@ accelerated styles exist. * :doc:`hbond/dreiding/lj ` - DREIDING hydrogen bonding LJ potential * :doc:`hbond/dreiding/morse ` - DREIDING hydrogen bonding Morse potential * :doc:`hdnnp ` - High-dimensional neural network potential -* :doc:`hippo ` - +* :doc:`hippo ` - * :doc:`ilp/graphene/hbn ` - registry-dependent interlayer potential (ILP) * :doc:`ilp/tmd ` - interlayer potential (ILP) potential for transition metal dichalcogenides (TMD) * :doc:`kim ` - interface to potentials provided by KIM project diff --git a/src/AMOEBA/amoeba_charge_transfer.cpp b/src/AMOEBA/amoeba_charge_transfer.cpp index e68921f733..3896c363bc 100644 --- a/src/AMOEBA/amoeba_charge_transfer.cpp +++ b/src/AMOEBA/amoeba_charge_transfer.cpp @@ -118,7 +118,7 @@ void PairAmoeba::charge_transfer() de = felec * de * factor_mpole; // use energy switching if near the cutoff distance - + if (r2 > cut2) { r3 = r2 * r; r4 = r2 * r2; @@ -165,7 +165,7 @@ void PairAmoeba::charge_transfer() // energy = e // virial = 6-vec vir // NOTE: add tally function - + if (evflag) { } } diff --git a/src/AMOEBA/amoeba_convolution.cpp b/src/AMOEBA/amoeba_convolution.cpp index fb1f7ce47c..fe97fd6144 100644 --- a/src/AMOEBA/amoeba_convolution.cpp +++ b/src/AMOEBA/amoeba_convolution.cpp @@ -58,8 +58,8 @@ enum{MPOLE_GRID,POLAR_GRID,POLAR_GRIDC,DISP_GRID,INDUCE_GRID,INDUCE_GRIDC}; ------------------------------------------------------------------------- */ AmoebaConvolution::AmoebaConvolution(LAMMPS *lmp, Pair *pair, - int nx_caller, int ny_caller, int nz_caller, - int order_caller, int which_caller) : + int nx_caller, int ny_caller, int nz_caller, + int order_caller, int which_caller) : Pointers(lmp) { amoeba = pair; @@ -73,9 +73,9 @@ AmoebaConvolution::AmoebaConvolution(LAMMPS *lmp, Pair *pair, if (which == POLAR_GRIDC || which == INDUCE_GRIDC) flag3d = 0; // NOTE: worry about overflow - + nfft_global = nx * ny * nz; - + // global indices of grid range from 0 to N-1 // nlo_in,nhi_in = lower/upper limits of the 3d sub-brick of // global grid that I own without ghost cells @@ -112,10 +112,10 @@ AmoebaConvolution::AmoebaConvolution(LAMMPS *lmp, Pair *pair, // convert to triclinic if necessary // nlo_out,nhi_out = nlo,nhi + stencil size for particle mapping // NOTE: this needs to be computed same as IGRID in amoeba - + double *prd,*boxlo,*sublo,*subhi; int triclinic = domain->triclinic; - + if (triclinic == 0) { prd = domain->prd; boxlo = domain->boxlo; @@ -153,7 +153,7 @@ AmoebaConvolution::AmoebaConvolution(LAMMPS *lmp, Pair *pair, nhi = static_cast ((subhi[2]+dist[2]-boxlo[2]) * nz/zprd); nzlo_out = nlo + nlower; nzhi_out = nhi + nupper; - + // x-pencil decomposition of FFT mesh // global indices range from 0 to N-1 // each proc owns entire x-dimension, clumps of columns in y,z dimensions @@ -166,7 +166,7 @@ AmoebaConvolution::AmoebaConvolution(LAMMPS *lmp, Pair *pair, int me = comm->me; int nprocs = comm->nprocs; - + int npey_fft,npez_fft; if (nz >= nprocs) { npey_fft = 1; @@ -189,7 +189,7 @@ AmoebaConvolution::AmoebaConvolution(LAMMPS *lmp, Pair *pair, // nfft_owned = owned grid points in FFT decomp // ngrid_either = max of nbrick_onwed and nfft_owned // nfft = total FFT grid points - + nbrick_owned = (nxhi_in-nxlo_in+1) * (nyhi_in-nylo_in+1) * (nzhi_in-nzlo_in+1); nbrick_ghosts = (nxhi_out-nxlo_out+1) * (nyhi_out-nylo_out+1) * @@ -202,43 +202,43 @@ AmoebaConvolution::AmoebaConvolution(LAMMPS *lmp, Pair *pair, // instantiate FFT, GridComm, and Remap int tmp; - + fft1 = new FFT3d(lmp,world,nx,ny,nz, - nxlo_fft,nxhi_fft,nylo_fft,nyhi_fft,nzlo_fft,nzhi_fft, - nxlo_fft,nxhi_fft,nylo_fft,nyhi_fft,nzlo_fft,nzhi_fft, + nxlo_fft,nxhi_fft,nylo_fft,nyhi_fft,nzlo_fft,nzhi_fft, + nxlo_fft,nxhi_fft,nylo_fft,nyhi_fft,nzlo_fft,nzhi_fft, 1,0,&tmp,0); - // 0,0,&tmp,0); + // 0,0,&tmp,0); fft2 = new FFT3d(lmp,world,nx,ny,nz, nxlo_fft,nxhi_fft,nylo_fft,nyhi_fft,nzlo_fft,nzhi_fft, nxlo_in,nxhi_in,nylo_in,nyhi_in,nzlo_in,nzhi_in, //1,0,&tmp,0); 0,0,&tmp,0); - + gc = new GridComm(lmp,world,nx,ny,nz, - nxlo_in,nxhi_in,nylo_in,nyhi_in,nzlo_in,nzhi_in, - nxlo_out,nxhi_out,nylo_out,nyhi_out,nzlo_out,nzhi_out); + nxlo_in,nxhi_in,nylo_in,nyhi_in,nzlo_in,nzhi_in, + nxlo_out,nxhi_out,nylo_out,nyhi_out,nzlo_out,nzhi_out); int nqty = flag3d ? 1 : 2; remap = new Remap(lmp,world, - nxlo_in,nxhi_in,nylo_in,nyhi_in,nzlo_in,nzhi_in, - nxlo_fft,nxhi_fft,nylo_fft,nyhi_fft,nzlo_fft,nzhi_fft, - nqty,0,0,FFT_PRECISION,0); - + nxlo_in,nxhi_in,nylo_in,nyhi_in,nzlo_in,nzhi_in, + nxlo_fft,nxhi_fft,nylo_fft,nyhi_fft,nzlo_fft,nzhi_fft, + nqty,0,0,FFT_PRECISION,0); + // memory allocations if (flag3d) { memory->create3d_offset(grid_brick,nzlo_out,nzhi_out,nylo_out,nyhi_out, - nxlo_out,nxhi_out,"amoeba:grid_brick"); + nxlo_out,nxhi_out,"amoeba:grid_brick"); grid_brick_start = &grid_brick[nzlo_out][nylo_out][nxlo_out]; cgrid_brick = NULL; } else { memory->create4d_offset_last(cgrid_brick,nzlo_out,nzhi_out,nylo_out,nyhi_out, - nxlo_out,nxhi_out,2,"amoeba:cgrid_brick"); + nxlo_out,nxhi_out,2,"amoeba:cgrid_brick"); grid_brick_start = &cgrid_brick[nzlo_out][nylo_out][nxlo_out][0]; grid_brick = NULL; } - + memory->create(grid_fft,ngrid_either,"amoeba:grid_fft"); memory->create(cfft,2*ngrid_either,"amoeba:cfft"); @@ -263,7 +263,7 @@ AmoebaConvolution::~AmoebaConvolution() memory->destroy(gc_buf1); memory->destroy(gc_buf2); memory->destroy(remap_buf); - + delete fft1; delete fft2; delete gc; @@ -288,7 +288,7 @@ void *AmoebaConvolution::zero_3d() { if (!grid_brick) return NULL; memset(&(grid_brick[nzlo_out][nylo_out][nxlo_out]),0, - nbrick_ghosts*sizeof(FFT_SCALAR)); + nbrick_ghosts*sizeof(FFT_SCALAR)); return (void *) grid_brick; } @@ -298,7 +298,7 @@ void *AmoebaConvolution::zero_4d() { if (!cgrid_brick) return NULL; memset(&(cgrid_brick[nzlo_out][nylo_out][nxlo_out][0]),0, - 2*nbrick_ghosts*sizeof(FFT_SCALAR)); + 2*nbrick_ghosts*sizeof(FFT_SCALAR)); return (void *) cgrid_brick; } @@ -327,11 +327,11 @@ FFT_SCALAR *AmoebaConvolution::pre_convolution_3d() if (DEBUG) debug_scalar(GRIDBRICK_OUT,"PRE Convo / PRE GridComm"); gc->reverse_comm(GridComm::PAIR,amoeba,1,sizeof(FFT_SCALAR),which, - gc_buf1,gc_buf2,MPI_FFT_SCALAR); + gc_buf1,gc_buf2,MPI_FFT_SCALAR); if (DEBUG) debug_scalar(GRIDBRICK_IN,"PRE Convo / POST GridComm"); if (DEBUG) debug_file(GRIDBRICK_IN,"pre.convo.post.gridcomm"); - + // copy owned 3d brick grid values to FFT grid n = 0; @@ -339,7 +339,7 @@ FFT_SCALAR *AmoebaConvolution::pre_convolution_3d() for (iy = nylo_in; iy <= nyhi_in; iy++) for (ix = nxlo_in; ix <= nxhi_in; ix++) grid_fft[n++] = grid_brick[iz][iy][ix]; - + // remap FFT grid from brick to x pencil partitioning remap->perform(grid_fft,grid_fft,remap_buf); @@ -348,7 +348,7 @@ FFT_SCALAR *AmoebaConvolution::pre_convolution_3d() if (DEBUG) debug_file(FFT,"pre.convo.post.remap"); // copy real values into complex grid - + n = 0; for (int i = 0; i < nfft_owned; i++) { cfft[n++] = grid_fft[i]; @@ -356,7 +356,7 @@ FFT_SCALAR *AmoebaConvolution::pre_convolution_3d() } // perform forward FFT - + fft1->compute(cfft,cfft,FFT3d::FORWARD); if (SCALE) { @@ -383,7 +383,7 @@ FFT_SCALAR *AmoebaConvolution::pre_convolution_4d() if (DEBUG) debug_scalar(GRIDBRICK_OUT,"PRE Convo / PRE GridComm"); gc->reverse_comm(GridComm::PAIR,amoeba,2,sizeof(FFT_SCALAR),which, - gc_buf1,gc_buf2,MPI_FFT_SCALAR); + gc_buf1,gc_buf2,MPI_FFT_SCALAR); if (DEBUG) debug_scalar(GRIDBRICK_IN,"PRE Convo / POST GridComm"); if (DEBUG) debug_file(GRIDBRICK_IN,"pre.convo.post.gridcomm"); @@ -400,14 +400,14 @@ FFT_SCALAR *AmoebaConvolution::pre_convolution_4d() // remap FFT grid from brick to x pencil partitioning // NOTE: could just setup FFT to start from brick decomp and skip remap - + remap->perform(cfft,cfft,remap_buf); if (DEBUG) debug_scalar(FFT,"PRE Convo / POST Remap"); if (DEBUG) debug_file(FFT,"pre.convo.post.remap"); // perform forward FFT - + fft1->compute(cfft,cfft,FFT3d::FORWARD); if (SCALE) { @@ -440,7 +440,7 @@ void *AmoebaConvolution::post_convolution() void *AmoebaConvolution::post_convolution_3d() { int ix,iy,iz,n; - + // perform backward FFT if (DEBUG) debug_scalar(CFFT1,"POST Convo / PRE FFT"); @@ -457,17 +457,17 @@ void *AmoebaConvolution::post_convolution_3d() for (iz = nzlo_in; iz <= nzhi_in; iz++) for (iy = nylo_in; iy <= nyhi_in; iy++) for (ix = nxlo_in; ix <= nxhi_in; ix++) { - grid_brick[iz][iy][ix] = cfft[n]; - n += 2; + grid_brick[iz][iy][ix] = cfft[n]; + n += 2; } - + // forward comm to populate ghost grid values if (DEBUG) debug_scalar(GRIDBRICK_IN,"POST Convo / PRE gridcomm"); if (DEBUG) debug_file(GRIDBRICK_IN,"post.convo.pre.gridcomm"); gc->forward_comm(GridComm::PAIR,amoeba,1,sizeof(FFT_SCALAR),which, - gc_buf1,gc_buf2,MPI_FFT_SCALAR); + gc_buf1,gc_buf2,MPI_FFT_SCALAR); return (void *) grid_brick; } @@ -496,17 +496,17 @@ void *AmoebaConvolution::post_convolution_4d() for (iz = nzlo_in; iz <= nzhi_in; iz++) for (iy = nylo_in; iy <= nyhi_in; iy++) for (ix = nxlo_in; ix <= nxhi_in; ix++) { - cgrid_brick[iz][iy][ix][0] = cfft[n++]; - cgrid_brick[iz][iy][ix][1] = cfft[n++]; + cgrid_brick[iz][iy][ix][0] = cfft[n++]; + cgrid_brick[iz][iy][ix][1] = cfft[n++]; } - + // forward comm to populate ghost grid values if (DEBUG) debug_scalar(GRIDBRICK_IN,"POST Convo / PRE gridcomm"); if (DEBUG) debug_file(GRIDBRICK_IN,"post.convo.pre.gridcomm"); gc->forward_comm(GridComm::PAIR,amoeba,2,sizeof(FFT_SCALAR),which, - gc_buf1,gc_buf2,MPI_FFT_SCALAR); + gc_buf1,gc_buf2,MPI_FFT_SCALAR); return (void *) cgrid_brick; } @@ -524,7 +524,7 @@ void AmoebaConvolution::kspacebbox(double r, double *b) { double *h = domain->h; double lx,ly,lz,xy,xz,yz; - + lx = h[0]; ly = h[1]; lz = h[2]; yz = h[3]; xz = h[4]; xy = h[5]; @@ -585,42 +585,42 @@ void AmoebaConvolution::debug_scalar(int array, const char *label) if (array == GRIDBRICK_OUT) { if (flag3d) { for (int iz = nzlo_out; iz <= nzhi_out; iz++) - for (int iy = nylo_out; iy <= nyhi_out; iy++) - for (int ix = nxlo_out; ix <= nxhi_out; ix++) - sum += grid_brick[iz][iy][ix]; + for (int iy = nylo_out; iy <= nyhi_out; iy++) + for (int ix = nxlo_out; ix <= nxhi_out; ix++) + sum += grid_brick[iz][iy][ix]; } else { for (int iz = nzlo_out; iz <= nzhi_out; iz++) - for (int iy = nylo_out; iy <= nyhi_out; iy++) - for (int ix = nxlo_out; ix <= nxhi_out; ix++) { - sum += cgrid_brick[iz][iy][ix][0]; - sum += cgrid_brick[iz][iy][ix][1]; - } + for (int iy = nylo_out; iy <= nyhi_out; iy++) + for (int ix = nxlo_out; ix <= nxhi_out; ix++) { + sum += cgrid_brick[iz][iy][ix][0]; + sum += cgrid_brick[iz][iy][ix][1]; + } } } if (array == GRIDBRICK_IN) { if (flag3d) { for (int iz = nzlo_in; iz <= nzhi_in; iz++) - for (int iy = nylo_in; iy <= nyhi_in; iy++) - for (int ix = nxlo_in; ix <= nxhi_in; ix++) - sum += grid_brick[iz][iy][ix]; + for (int iy = nylo_in; iy <= nyhi_in; iy++) + for (int ix = nxlo_in; ix <= nxhi_in; ix++) + sum += grid_brick[iz][iy][ix]; } else { for (int iz = nzlo_in; iz <= nzhi_in; iz++) - for (int iy = nylo_in; iy <= nyhi_in; iy++) - for (int ix = nxlo_in; ix <= nxhi_in; ix++) { - sum += cgrid_brick[iz][iy][ix][0]; - sum += cgrid_brick[iz][iy][ix][1]; - } + for (int iy = nylo_in; iy <= nyhi_in; iy++) + for (int ix = nxlo_in; ix <= nxhi_in; ix++) { + sum += cgrid_brick[iz][iy][ix][0]; + sum += cgrid_brick[iz][iy][ix][1]; + } } } if (array == FFT) { if (flag3d) { for (int i = 0; i < nfft_owned; i++) - sum += grid_fft[i]; + sum += grid_fft[i]; } else { for (int i = 0; i < 2*nfft_owned; i++) - sum += cfft[i]; + sum += cfft[i]; } } @@ -628,13 +628,13 @@ void AmoebaConvolution::debug_scalar(int array, const char *label) for (int i = 0; i < 2*nfft_owned; i++) sum += cfft[i]; } - + if (array == CFFT2) { for (int i = 0; i < 2*nbrick_owned; i++) sum += cfft[i]; } - - /* + + /* double sumall; MPI_Allreduce(&sum,&sumall,1,MPI_DOUBLE,MPI_SUM,world); if (comm->me == 0) printf("%s: %s: %12.8g\n",labels[which],label,sumall); @@ -654,14 +654,14 @@ void AmoebaConvolution::debug_file(int array, const char *label) int nprocs = comm->nprocs; // open file - + char fname[128]; sprintf(fname,"tmp.%s.%s",labels[which],label); if (me == 0) fp = fopen(fname,"w"); // file header // ncol = # of columns, including grid cell ID - + bigint ntot = nx * ny * nz; int ncol; @@ -701,58 +701,58 @@ void AmoebaConvolution::debug_file(int array, const char *label) int ngridmax; MPI_Allreduce(&ngrid,&ngridmax,1,MPI_INT,MPI_MAX,world); - + double *buf,*buf2; memory->create(buf,ncol*ngridmax,"amoeba:buf"); memory->create(buf2,ncol*ngridmax,"amoeba:buf2"); ngrid = 0; - + if (array == GRIDBRICK_IN) { if (flag3d) { for (int iz = nzlo_in; iz <= nzhi_in; iz++) - for (int iy = nylo_in; iy <= nyhi_in; iy++) - for (int ix = nxlo_in; ix <= nxhi_in; ix++) { - int id = iz*ny*nx + iy*nx + ix + 1; - buf[ncol*ngrid] = id; - buf[ncol*ngrid+1] = grid_brick[iz][iy][ix]; - ngrid++; - } + for (int iy = nylo_in; iy <= nyhi_in; iy++) + for (int ix = nxlo_in; ix <= nxhi_in; ix++) { + int id = iz*ny*nx + iy*nx + ix + 1; + buf[ncol*ngrid] = id; + buf[ncol*ngrid+1] = grid_brick[iz][iy][ix]; + ngrid++; + } } else { for (int iz = nzlo_in; iz <= nzhi_in; iz++) - for (int iy = nylo_in; iy <= nyhi_in; iy++) - for (int ix = nxlo_in; ix <= nxhi_in; ix++) { - int id = iz*ny*nx + iy*nx + ix + 1; - buf[ncol*ngrid] = id; - buf[ncol*ngrid+1] = cgrid_brick[iz][iy][ix][0]; - buf[ncol*ngrid+2] = cgrid_brick[iz][iy][ix][1]; - ngrid++; - } + for (int iy = nylo_in; iy <= nyhi_in; iy++) + for (int ix = nxlo_in; ix <= nxhi_in; ix++) { + int id = iz*ny*nx + iy*nx + ix + 1; + buf[ncol*ngrid] = id; + buf[ncol*ngrid+1] = cgrid_brick[iz][iy][ix][0]; + buf[ncol*ngrid+2] = cgrid_brick[iz][iy][ix][1]; + ngrid++; + } } } - + if (array == FFT) { if (flag3d) { int m = 0; for (int iz = nzlo_fft; iz <= nzhi_fft; iz++) - for (int iy = nylo_fft; iy <= nyhi_fft; iy++) - for (int ix = nxlo_fft; ix <= nxhi_fft; ix++) { - int id = iz*ny*nx + iy*nx + ix + 1; - buf[ncol*ngrid] = id; - buf[ncol*ngrid+1] = grid_fft[m++]; - ngrid++; - } - } else { + for (int iy = nylo_fft; iy <= nyhi_fft; iy++) + for (int ix = nxlo_fft; ix <= nxhi_fft; ix++) { + int id = iz*ny*nx + iy*nx + ix + 1; + buf[ncol*ngrid] = id; + buf[ncol*ngrid+1] = grid_fft[m++]; + ngrid++; + } + } else { int m = 0; for (int iz = nzlo_fft; iz <= nzhi_fft; iz++) - for (int iy = nylo_fft; iy <= nyhi_fft; iy++) - for (int ix = nxlo_fft; ix <= nxhi_fft; ix++) { - int id = iz*ny*nx + iy*nx + ix + 1; - buf[ncol*ngrid] = id; - buf[ncol*ngrid+1] = cfft[m++]; - buf[ncol*ngrid+2] = cfft[m++]; - ngrid++; - } + for (int iy = nylo_fft; iy <= nyhi_fft; iy++) + for (int ix = nxlo_fft; ix <= nxhi_fft; ix++) { + int id = iz*ny*nx + iy*nx + ix + 1; + buf[ncol*ngrid] = id; + buf[ncol*ngrid+1] = cfft[m++]; + buf[ncol*ngrid+2] = cfft[m++]; + ngrid++; + } } } @@ -760,62 +760,62 @@ void AmoebaConvolution::debug_file(int array, const char *label) int m = 0; for (int iz = nzlo_fft; iz <= nzhi_fft; iz++) for (int iy = nylo_fft; iy <= nyhi_fft; iy++) - for (int ix = nxlo_fft; ix <= nxhi_fft; ix++) { - int id = iz*ny*nx + iy*nx + ix + 1; - buf[ncol*ngrid] = id; - buf[ncol*ngrid+1] = cfft[m++]; - buf[ncol*ngrid+2] = cfft[m++]; - ngrid++; - } + for (int ix = nxlo_fft; ix <= nxhi_fft; ix++) { + int id = iz*ny*nx + iy*nx + ix + 1; + buf[ncol*ngrid] = id; + buf[ncol*ngrid+1] = cfft[m++]; + buf[ncol*ngrid+2] = cfft[m++]; + ngrid++; + } } if (array == CFFT2) { int m = 0; for (int iz = nzlo_in; iz <= nzhi_in; iz++) for (int iy = nylo_in; iy <= nyhi_in; iy++) - for (int ix = nxlo_in; ix <= nxhi_in; ix++) { - int id = iz*ny*nx + iy*nx + ix + 1; - buf[ncol*ngrid] = id; - buf[ncol*ngrid+1] = cfft[m++]; - buf[ncol*ngrid+2] = cfft[m++]; - ngrid++; - } + for (int ix = nxlo_in; ix <= nxhi_in; ix++) { + int id = iz*ny*nx + iy*nx + ix + 1; + buf[ncol*ngrid] = id; + buf[ncol*ngrid+1] = cfft[m++]; + buf[ncol*ngrid+2] = cfft[m++]; + ngrid++; + } } - + // proc 0 outputs values // pings other procs, send/recv of their values int tmp,nlines; MPI_Request request; MPI_Status status; - + if (me == 0) { for (int iproc = 0; iproc < nprocs; iproc++) { if (iproc) { - MPI_Irecv(buf,ngridmax*ncol,MPI_DOUBLE,iproc,0,world,&request); - MPI_Send(&tmp,0,MPI_INT,me+iproc,0,world); - MPI_Wait(&request,&status); - MPI_Get_count(&status,MPI_DOUBLE,&nlines); - nlines /= ncol; + MPI_Irecv(buf,ngridmax*ncol,MPI_DOUBLE,iproc,0,world,&request); + MPI_Send(&tmp,0,MPI_INT,me+iproc,0,world); + MPI_Wait(&request,&status); + MPI_Get_count(&status,MPI_DOUBLE,&nlines); + nlines /= ncol; } else nlines = ngrid; int n = 0; for (int m = 0; m < nlines; m++) { - if (ncol == 2) - fprintf(fp,"%d %12.8g\n",(int) buf[n],buf[n+1]); - else if (ncol == 3) - fprintf(fp,"%d %12.8g %12.8g\n",(int ) buf[n],buf[n+1],buf[n+2]); - n += ncol; + if (ncol == 2) + fprintf(fp,"%d %12.8g\n",(int) buf[n],buf[n+1]); + else if (ncol == 3) + fprintf(fp,"%d %12.8g %12.8g\n",(int ) buf[n],buf[n+1],buf[n+2]); + n += ncol; } } - + } else { MPI_Recv(&tmp,0,MPI_INT,0,0,world,MPI_STATUS_IGNORE); MPI_Rsend(buf,ngrid*ncol,MPI_DOUBLE,0,0,world); } - + // close file - + if (me == 0) fclose(fp); // clean up diff --git a/src/AMOEBA/amoeba_convolution.h b/src/AMOEBA/amoeba_convolution.h index 4821a034be..94502d3691 100644 --- a/src/AMOEBA/amoeba_convolution.h +++ b/src/AMOEBA/amoeba_convolution.h @@ -39,14 +39,14 @@ class AmoebaConvolution : protected Pointers { int nxlo_out,nxhi_out,nylo_out,nyhi_out,nzlo_out,nzhi_out; int nxlo_fft,nxhi_fft,nylo_fft,nyhi_fft,nzlo_fft,nzhi_fft; double *grid_brick_start; // lower left corner of (c)grid_brick data - + AmoebaConvolution(class LAMMPS *, class Pair *, - int, int, int, int, int); + int, int, int, int, int); ~AmoebaConvolution(); void *zero(); FFT_SCALAR *pre_convolution(); void *post_convolution(); - + private: int which; // caller name for convolution being performed int flag3d; // 1 if using 3d grid_brick, 0 for 4d cgrid_brick @@ -58,13 +58,13 @@ class AmoebaConvolution : protected Pointers { class FFT3d *fft1,*fft2; class GridComm *gc; class Remap *remap; - + double ***grid_brick; // 3d real brick grid with ghosts double ****cgrid_brick; // 4d complex brick grid with ghosts - + FFT_SCALAR *grid_fft; // 3d FFT grid as 1d vector FFT_SCALAR *cfft; // 3d complex FFT grid as 1d vector - + double *gc_buf1,*gc_buf2; // buffers for GridComm double *remap_buf; // buffer for Remap diff --git a/src/AMOEBA/amoeba_dispersion.cpp b/src/AMOEBA/amoeba_dispersion.cpp index d7d66e7f42..ffd57c4044 100644 --- a/src/AMOEBA/amoeba_dispersion.cpp +++ b/src/AMOEBA/amoeba_dispersion.cpp @@ -97,7 +97,7 @@ void PairAmoeba::dispersion_real() int *ilist,*jlist,*numneigh,**firstneigh; // owned atoms - + double **x = atom->x; double **f = atom->f; int nlocal = atom->nlocal; @@ -172,10 +172,10 @@ void PairAmoeba::dispersion_real() tk2 = tk * tk; damp3 = 1.0 - ti2*(1.0+di+0.5*di2)*expi - tk2*(1.0+dk+0.5*dk2)*expk - 2.0*ti2*tk*(1.0+di)*expi - 2.0*tk2*ti*(1.0+dk)*expk; - damp5 = 1.0 - ti2*(1.0+di+0.5*di2+di3/6.0)*expi - - tk2*(1.0+dk+0.5*dk2 + dk3/6.0)*expk - + damp5 = 1.0 - ti2*(1.0+di+0.5*di2+di3/6.0)*expi - + tk2*(1.0+dk+0.5*dk2 + dk3/6.0)*expk - 2.0*ti2*tk*(1.0+di+di2/3.0)*expi - 2.0*tk2*ti*(1.0+dk+dk2/3.0)*expk; - ddamp = 0.25 * di2 * ti2 * ai * expi * (r*ai+4.0*tk-1.0) + + ddamp = 0.25 * di2 * ti2 * ai * expi * (r*ai+4.0*tk-1.0) + 0.25 * dk2 * tk2 * ak * expk * (r*ak+4.0*ti-1.0); } else { @@ -187,7 +187,7 @@ void PairAmoeba::dispersion_real() } damp = 1.5*damp5 - 0.5*damp3; - + // apply damping and scaling factors for this interaction scale = factor_disp * damp*damp; @@ -229,7 +229,7 @@ void PairAmoeba::dispersion_real() // energy = e // virial = 6-vec vir // NOTE: add tally function - + if (evflag) { } } @@ -298,11 +298,11 @@ void PairAmoeba::dispersion_kspace() // pre-convolution operations including forward FFT // gridfft = my portion of complex 3d grid in FFT decomposition - + double *gridfft = d_kspace->pre_convolution(); // --------------------- - // convolution operation + // convolution operation // --------------------- nhalf1 = (nfft1+1) / 2; @@ -329,39 +329,39 @@ void PairAmoeba::dispersion_kspace() for (k = nzlo; k <= nzhi; k++) { for (j = nylo; j <= nyhi; j++) { for (i = nxlo; i <= nxhi; i++) { - r1 = (i >= nhalf1) ? i-nfft1 : i; - r2 = (j >= nhalf2) ? j-nfft2 : j; - r3 = (k >= nhalf3) ? k-nfft3 : k; - h1 = recip[0][0]*r1 + recip[0][1]*r2 + recip[0][2]*r3; // matvec - h2 = recip[1][0]*r1 + recip[1][1]*r2 + recip[1][2]*r3; - h3 = recip[2][0]*r1 + recip[2][1]*r2 + recip[2][2]*r3; - hsq = h1*h1 + h2*h2 + h3*h3; - h = sqrt(hsq); - b = h*bfac; - hhh = h*hsq; - term = -b*b; - expterm = 0.0; - erfcterm = erfc(b); - denom = denom0*bsmod1[i]*bsmod2[j]*bsmod3[k]; - if (term > -50.0 && hsq != 0.0) { - expterm = exp(term); - erfcterm = erfc(b); - term1 = fac1*erfcterm*hhh + expterm*(fac2 + fac3*hsq); - struc2 = gridfft[n]*gridfft[n] + gridfft[n+1]*gridfft[n+1]; - e = -(term1 / denom) * struc2; - edisp += e; - vterm = 3.0 * (fac1*erfcterm*h + fac3*expterm) * struc2/denom; - virdisp[0] += h1*h1*vterm - e; - virdisp[1] += h2*h2*vterm - e; - virdisp[2] += h3*h3*vterm - e; - virdisp[3] += h1*h2*vterm; - virdisp[4] += h1*h3*vterm; - virdisp[5] += h2*h3*vterm; - } else term1 = 0.0; - // NOTE: pre-calc this division only once - gridfft[n] *= -(term1/denom); - gridfft[n+1] *= -(term1/denom); - n += 2; + r1 = (i >= nhalf1) ? i-nfft1 : i; + r2 = (j >= nhalf2) ? j-nfft2 : j; + r3 = (k >= nhalf3) ? k-nfft3 : k; + h1 = recip[0][0]*r1 + recip[0][1]*r2 + recip[0][2]*r3; // matvec + h2 = recip[1][0]*r1 + recip[1][1]*r2 + recip[1][2]*r3; + h3 = recip[2][0]*r1 + recip[2][1]*r2 + recip[2][2]*r3; + hsq = h1*h1 + h2*h2 + h3*h3; + h = sqrt(hsq); + b = h*bfac; + hhh = h*hsq; + term = -b*b; + expterm = 0.0; + erfcterm = erfc(b); + denom = denom0*bsmod1[i]*bsmod2[j]*bsmod3[k]; + if (term > -50.0 && hsq != 0.0) { + expterm = exp(term); + erfcterm = erfc(b); + term1 = fac1*erfcterm*hhh + expterm*(fac2 + fac3*hsq); + struc2 = gridfft[n]*gridfft[n] + gridfft[n+1]*gridfft[n+1]; + e = -(term1 / denom) * struc2; + edisp += e; + vterm = 3.0 * (fac1*erfcterm*h + fac3*expterm) * struc2/denom; + virdisp[0] += h1*h1*vterm - e; + virdisp[1] += h2*h2*vterm - e; + virdisp[2] += h3*h3*vterm - e; + virdisp[3] += h1*h2*vterm; + virdisp[4] += h1*h3*vterm; + virdisp[5] += h2*h3*vterm; + } else term1 = 0.0; + // NOTE: pre-calc this division only once + gridfft[n] *= -(term1/denom); + gridfft[n+1] *= -(term1/denom); + n += 2; } } } @@ -371,7 +371,7 @@ void PairAmoeba::dispersion_kspace() double ***gridpost = (double ***) d_kspace->post_convolution(); - // get first derivatives of the reciprocal space energy + // get first derivatives of the reciprocal space energy int nlpts = (bsorder-1) / 2; int nrpts = bsorder - nlpts - 1; @@ -391,17 +391,17 @@ void PairAmoeba::dispersion_kspace() t2 = thetai2[m][jb][0]; dt2 = nfft2 * thetai2[m][jb][1]; - i = igrid[m][0] - nlpts; - for (ib = 0; ib < bsorder; ib++) { - t1 = thetai1[m][ib][0]; + i = igrid[m][0] - nlpts; + for (ib = 0; ib < bsorder; ib++) { + t1 = thetai1[m][ib][0]; dt1 = nfft1 * thetai1[m][ib][1]; term = gridpost[k][j][i]; de1 += 2.0*term*dt1*t2*t3; de2 += 2.0*term*dt2*t1*t3; de3 += 2.0*term*dt3*t1*t2; - i++; + i++; } - j++; + j++; } k++; } @@ -415,7 +415,7 @@ void PairAmoeba::dispersion_kspace() // account for the energy and virial correction terms term = csixpr * aewald*aewald*aewald / denom0; - + if (me == 0) { edisp -= term; virdisp[0] += term; diff --git a/src/AMOEBA/amoeba_file.cpp b/src/AMOEBA/amoeba_file.cpp index f67eacd879..e1d57e165d 100644 --- a/src/AMOEBA/amoeba_file.cpp +++ b/src/AMOEBA/amoeba_file.cpp @@ -135,7 +135,7 @@ void PairAmoeba::read_prmfile(char *filename) if (forcefield_flag == 0 && section != FFIELD) error->all(FLERR,"Force Field is not first section of " "pair amoeba potential file"); - if (section != FFIELD && section != LITERATURE && section != ATOMTYPE && + if (section != FFIELD && section != LITERATURE && section != ATOMTYPE && section != UNKNOWN && atomtype_flag == 0) error->all(FLERR,"Atom Type section of pair amoeba potential file " "must come before all but Force Field section"); @@ -159,8 +159,8 @@ void PairAmoeba::read_prmfile(char *filename) // convert all chars in line to lower-case for (int i = 0; i < n; i++) - line[i] = tolower(line[i]); - + line[i] = tolower(line[i]); + char *copy; char **words; int nwords = tokenize(line,words,copy); @@ -205,11 +205,11 @@ void PairAmoeba::read_prmfile(char *filename) void PairAmoeba::read_keyfile(char *filename) { double aprd,bprd,cprd; - + // default settings for which there are keyword options aprd = bprd = cprd = 0.0; - + vdwcut = 9.0; vdwtaper = 0.9 * vdwcut; repcut = 6.0; @@ -254,7 +254,7 @@ void PairAmoeba::read_keyfile(char *filename) // done if keyfile not specified by pair_coeff command if (!filename) return; - + // open key file int me = comm->me; @@ -320,14 +320,14 @@ void PairAmoeba::read_keyfile(char *filename) if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); double taper = utils::numeric(FLERR,words[1],true,lmp); if (taper >= 1.0) { - vdwtaper = reptaper = disptaper = mpoletaper = ctrntaper = taper; + vdwtaper = reptaper = disptaper = mpoletaper = ctrntaper = taper; } else { - taper = -taper; - vdwtaper = taper * vdwcut; - reptaper = taper * repcut; - disptaper = taper * dispcut; - mpoletaper = taper * mpolecut; - ctrntaper = taper * ctrncut; + taper = -taper; + vdwtaper = taper * vdwcut; + reptaper = taper * repcut; + disptaper = taper * dispcut; + mpoletaper = taper * mpolecut; + ctrntaper = taper * ctrncut; } } else if (strcmp(keyword,"vdw-cutoff") == 0) { if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); @@ -396,7 +396,7 @@ void PairAmoeba::read_keyfile(char *filename) } else if (strcmp(keyword,"dewald") == 0) { if (nwords != 1) error->all(FLERR,"AMOEBA keyfile line is invalid"); use_dewald = 1; - + } else if (strcmp(keyword,"pme-order") == 0) { if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); bseorder = utils::numeric(FLERR,words[1],true,lmp); @@ -409,24 +409,24 @@ void PairAmoeba::read_keyfile(char *filename) } else if (strcmp(keyword,"pme-grid") == 0) { if (nwords != 2 && nwords != 4) - error->all(FLERR,"AMOEBA keyfile line is invalid"); + error->all(FLERR,"AMOEBA keyfile line is invalid"); if (nwords == 2) - nefft1 = nefft2 = nefft3 = utils::numeric(FLERR,words[1],true,lmp); + nefft1 = nefft2 = nefft3 = utils::numeric(FLERR,words[1],true,lmp); else { - nefft1 = utils::numeric(FLERR,words[1],true,lmp); - nefft2 = utils::numeric(FLERR,words[2],true,lmp); - nefft3 = utils::numeric(FLERR,words[3],true,lmp); + nefft1 = utils::numeric(FLERR,words[1],true,lmp); + nefft2 = utils::numeric(FLERR,words[2],true,lmp); + nefft3 = utils::numeric(FLERR,words[3],true,lmp); } pmegrid_key = 1; } else if (strcmp(keyword,"dpme-grid") == 0) { if (nwords != 2 && nwords != 4) - error->all(FLERR,"AMOEBA keyfile line is invalid"); + error->all(FLERR,"AMOEBA keyfile line is invalid"); if (nwords == 2) - ndfft1 = ndfft2 = ndfft3 = utils::numeric(FLERR,words[1],true,lmp); + ndfft1 = ndfft2 = ndfft3 = utils::numeric(FLERR,words[1],true,lmp); else { - ndfft1 = utils::numeric(FLERR,words[1],true,lmp); - ndfft2 = utils::numeric(FLERR,words[2],true,lmp); - ndfft3 = utils::numeric(FLERR,words[3],true,lmp); + ndfft1 = utils::numeric(FLERR,words[1],true,lmp); + ndfft2 = utils::numeric(FLERR,words[2],true,lmp); + ndfft3 = utils::numeric(FLERR,words[3],true,lmp); } dpmegrid_key = 1; @@ -448,27 +448,27 @@ void PairAmoeba::read_keyfile(char *filename) } else if (strcmp(words[0],"polarization") == 0) { if (strcmp(words[1],"mutual") == 0) poltyp = MUTUAL; else if (strstr(words[1],"opt") == words[1]) { - poltyp = OPT; - if (strcmp(words[1],"opt") == 0) optorder = 4; - else optorder = utils::inumeric(FLERR,&words[1][3],true,lmp); - if (optorder < 1 || optorder > 6) - error->all(FLERR,"Unrecognized polarization OPTn in AMOEBA FF file"); + poltyp = OPT; + if (strcmp(words[1],"opt") == 0) optorder = 4; + else optorder = utils::inumeric(FLERR,&words[1][3],true,lmp); + if (optorder < 1 || optorder > 6) + error->all(FLERR,"Unrecognized polarization OPTn in AMOEBA FF file"); } else if (strcmp(words[1],"tcg") == 0) - error->all(FLERR,"Polarization TCG not yet supported in AMOEBA/HIPPO"); + error->all(FLERR,"Polarization TCG not yet supported in AMOEBA/HIPPO"); else if (strcmp(words[1],"direct") == 0) poltyp = DIRECT; else error->all(FLERR,"Unrecognized polarization in AMOEBA FF file"); } else if (strcmp(keyword,"polar-predict") == 0) { if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); if (strcmp(words[1],"gear") == 0) { - polpred = GEAR; - maxualt = 7; + polpred = GEAR; + maxualt = 7; } else if (strcmp(words[1],"aspc") == 0) { - polpred = ASPC; - maxualt = 17; + polpred = ASPC; + maxualt = 17; } else if (strcmp(words[1],"lsqr") == 0) { - polpred = LSQR; - maxualt = 7; + polpred = LSQR; + maxualt = 7; } else error->all(FLERR,"AMOEBA keyfile line is invalid"); use_pred = 1; } else if (strcmp(keyword,"polar-iter") == 0) { @@ -493,7 +493,7 @@ void PairAmoeba::read_keyfile(char *filename) } else if (strcmp(keyword,"pcg-peek") == 0) { if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); pcgpeek = utils::numeric(FLERR,words[1],true,lmp); - + } else {} delete [] copy; @@ -501,14 +501,14 @@ void PairAmoeba::read_keyfile(char *filename) } // close key file - + if (me == 0) fclose(fptr); // cutoff resets for long-range interactions if (use_ewald) mpolecut = ewaldcut; if (use_dewald) dispcut = dewaldcut; - + // error checks if (use_ewald || use_dewald) { @@ -555,8 +555,8 @@ int PairAmoeba::read_section_name(FILE *fp, char *line) } break; } - - if ((strstr(words[0],"##") != words[0]) || + + if ((strstr(words[0],"##") != words[0]) || (strstr(words[nwords-1],"##") != words[nwords-1])) error->one(FLERR,"Section header of pair amoeba potential file is invalid"); @@ -580,7 +580,7 @@ int PairAmoeba::read_section_name(FILE *fp, char *line) /* ---------------------------------------------------------------------- */ -int PairAmoeba::read_section_line(FILE *fp, char *line, +int PairAmoeba::read_section_line(FILE *fp, char *line, int &nextflag, char *next) { // loop on read line @@ -594,7 +594,7 @@ int PairAmoeba::read_section_line(FILE *fp, char *line, // until a line is blank, starts with #, starts with alpha char, or EOF // save next line read, and set nextflag for next call // return length of line - + char *ptr,*copy,*copy_next; char **words,**words_next; int nwords,nwords_next; @@ -776,7 +776,7 @@ void PairAmoeba::file_ffield(int nwords, char **words) poltyp = OPT; if (strcmp(words[1],"opt") == 0) optorder = 4; else optorder = utils::inumeric(FLERR,&words[1][3],true,lmp); - if (optorder < 1 || optorder > 6) + if (optorder < 1 || optorder > 6) error->all(FLERR,"Unrecognized polarization OPTn in AMOEBA FF file"); } else if (strcmp(words[1],"tcg") == 0) error->all(FLERR,"Polarization TCG not yet supported in AMOEBA/HIPPO"); @@ -785,7 +785,7 @@ void PairAmoeba::file_ffield(int nwords, char **words) // NOTE: enable all variants of special settings // do these need to be set to defaults if don't appear in file? - + } else if (strcmp(words[0],"vdw-12-scale") == 0) { special_hal[1] = utils::numeric(FLERR,words[1],true,lmp); } else if (strcmp(words[0],"vdw-13-scale") == 0) { @@ -883,9 +883,9 @@ void PairAmoeba::file_atomtype(int nwords, char **words) { if (nwords < 8) error->all(FLERR,"AMOEBA atom type line is invalid"); - if (strcmp(words[0],"atom") != 0) + if (strcmp(words[0],"atom") != 0) error->all(FLERR,"AMOEBA atom type line is invalid"); - + int itype = utils::inumeric(FLERR,words[1],true,lmp); int iclass = utils::inumeric(FLERR,words[2],true,lmp); @@ -913,7 +913,7 @@ void PairAmoeba::file_vdwl(int nwords, char **words) { if (nwords != 4 && nwords != 5) error->all(FLERR,"AMOEBA Van der Waals line is invalid"); - if (strcmp(words[0],"vdw") != 0) + if (strcmp(words[0],"vdw") != 0) error->all(FLERR,"AMOEBA Van der Waals line is invalid"); int iclass = utils::inumeric(FLERR,words[1],true,lmp); @@ -930,9 +930,9 @@ void PairAmoeba::file_vdwl(int nwords, char **words) void PairAmoeba::file_vdwl_pair(int nwords, char **words) { - if (nwords != 5) + if (nwords != 5) error->all(FLERR,"AMOEBA Van der Waals pair line is invalid"); - if (strcmp(words[0],"vdwpr") != 0) + if (strcmp(words[0],"vdwpr") != 0) error->all(FLERR,"AMOEBA Van der Waals pair line is invalid"); if (nvdwl_pair == max_vdwl_pair) { @@ -955,7 +955,7 @@ void PairAmoeba::file_bstretch(int nwords, char **words) { if (nwords < 5) error->all(FLERR,"AMOEBA bond stretch line is invalid"); - if (strcmp(words[0],"bond") != 0) + if (strcmp(words[0],"bond") != 0) error->all(FLERR,"AMOEBA bond stretch line is invalid"); } @@ -963,9 +963,9 @@ void PairAmoeba::file_bstretch(int nwords, char **words) void PairAmoeba::file_sbend(int nwords, char **words) { - if (nwords != 6) + if (nwords != 6) error->all(FLERR,"AMOEBA strectch-bend line is invalid"); - if (strstr(words[0],"strbnd") != words[0]) + if (strstr(words[0],"strbnd") != words[0]) error->all(FLERR,"AMOEBA strectch-bend line is invalid"); } @@ -983,7 +983,7 @@ void PairAmoeba::file_pauli(int nwords, char **words) { if (nwords < 5) error->all(FLERR,"AMOEBA Pauli repulsion line is invalid"); - if (strstr(words[0],"repulsion") != words[0]) + if (strstr(words[0],"repulsion") != words[0]) error->all(FLERR,"AMOEBA Pauli repulsion line is invalid"); int itype = utils::inumeric(FLERR,words[1],true,lmp); @@ -1003,7 +1003,7 @@ void PairAmoeba::file_dispersion(int nwords, char **words) { if (nwords < 4) error->all(FLERR,"AMOEBA dispersion line is invalid"); - if (strstr(words[0],"dispersion") != words[0]) + if (strstr(words[0],"dispersion") != words[0]) error->all(FLERR,"AMOEBA dipersion line is invalid"); int iclass = utils::inumeric(FLERR,words[1],true,lmp); @@ -1020,7 +1020,7 @@ void PairAmoeba::file_ub(int nwords, char **words) { if (nwords != 6) error->all(FLERR,"AMOEBA Urey-Bradley line is invalid"); - if (strstr(words[0],"ureybrad") != words[0]) + if (strstr(words[0],"ureybrad") != words[0]) error->all(FLERR,"AMOEBA Urey-Bradley line is invalid"); } @@ -1030,7 +1030,7 @@ void PairAmoeba::file_outplane(int nwords, char **words) { if (nwords != 6) error->all(FLERR,"AMOEBA out-of-plane bend line is invalid"); - if (strstr(words[0],"opbend") != words[0]) + if (strstr(words[0],"opbend") != words[0]) error->all(FLERR,"AMOEBA out-of-plane bend line is invalid"); } @@ -1040,7 +1040,7 @@ void PairAmoeba::file_torsion(int nwords, char **words) { if (nwords != 14) error->all(FLERR,"AMOEBA torsional line is invalid"); - if (strstr(words[0],"torsion") != words[0]) + if (strstr(words[0],"torsion") != words[0]) error->all(FLERR,"AMOEBA torsional line is invalid"); } @@ -1060,7 +1060,7 @@ void PairAmoeba::file_multipole(int nwords, char **words) { if (nwords < 12 || nwords > 15) error->all(FLERR,"AMOEBA atomic multipole line is invalid"); - if (strstr(words[0],"multipole") != words[0]) + if (strstr(words[0],"multipole") != words[0]) error->all(FLERR,"AMOEBA atomic multipole line is invalid"); int itype = utils::inumeric(FLERR,words[1],true,lmp); @@ -1070,7 +1070,7 @@ void PairAmoeba::file_multipole(int nwords, char **words) int iframe = nmultiframe[itype]; if (iframe == MAX_FRAME_PER_TYPE) error->all(FLERR,"AMOEBA MAX_FRAME_PER_TYPE is too small"); - + int extra; if (nwords == 12) { zpole[itype][iframe] = xpole[itype][iframe] = ypole[itype][iframe] = 0; @@ -1116,7 +1116,7 @@ void PairAmoeba::file_multipole(int nwords, char **words) // quadrupole terms divided by 3 for use as traceless values for (int i = 1; i < 4; i++) - fpole[itype][iframe][i] *= BOHR; + fpole[itype][iframe][i] *= BOHR; for (int i = 4; i < 13; i++) fpole[itype][iframe][i] *= BOHR*BOHR / 3.0; @@ -1135,7 +1135,7 @@ void PairAmoeba::file_multipole(int nwords, char **words) xyzmax = MAX(xyzmax,ypole[itype][iframe]); if (xyzmax < 0) mpaxis[itype][iframe] = THREEFOLD; if (mpaxis[itype][iframe] < 0) error->all(FLERR,"Mpaxis value not set"); - + // now reset xyz pole to positive values if (xpole[itype][iframe] < 0) xpole[itype][iframe] = -xpole[itype][iframe]; @@ -1151,7 +1151,7 @@ void PairAmoeba::file_charge_penetration(int nwords, char **words) { if (nwords < 4) error->all(FLERR,"AMOEBA charge penetration line is invalid"); - if (strstr(words[0],"chgpen") != words[0]) + if (strstr(words[0],"chgpen") != words[0]) error->all(FLERR,"AMOEBA charge penetration line is invalid"); int iclass = utils::inumeric(FLERR,words[1],true,lmp); @@ -1172,7 +1172,7 @@ void PairAmoeba::file_dippolar(int nwords, char **words) if (nwords < nparams) error->all(FLERR,"AMOEBA dipole polarizability line is invalid"); - if (strstr(words[0],"polarize") != words[0]) + if (strstr(words[0],"polarize") != words[0]) error->all(FLERR,"AMOEBA dipole polarizability line is invalid"); int itype = utils::inumeric(FLERR,words[1],true,lmp); @@ -1193,7 +1193,7 @@ void PairAmoeba::file_dippolar(int nwords, char **words) npolgroup[itype] = ngroup; for (int igroup = 0; igroup < ngroup; igroup++) - polgroup[itype][igroup] = + polgroup[itype][igroup] = utils::inumeric(FLERR,words[nparams+igroup],true,lmp); } @@ -1203,7 +1203,7 @@ void PairAmoeba::file_charge_transfer(int nwords, char **words) { if (nwords < 4) error->all(FLERR,"AMOEBA charge transfer line is invalid"); - if (strstr(words[0],"chgtrn") != words[0]) + if (strstr(words[0],"chgtrn") != words[0]) error->all(FLERR,"AMOEBA charge transfer line is invalid"); int iclass = utils::inumeric(FLERR,words[1],true,lmp); @@ -1223,7 +1223,7 @@ void PairAmoeba::initialize_type_class() n_amtype = n_amclass = 0; max_amtype = max_amclass = 0; nvdwl_pair = max_vdwl_pair = 0; - + // per type data amtype_defined = NULL; diff --git a/src/AMOEBA/amoeba_hal.cpp b/src/AMOEBA/amoeba_hal.cpp index 3dd7663528..6e69baa11c 100644 --- a/src/AMOEBA/amoeba_hal.cpp +++ b/src/AMOEBA/amoeba_hal.cpp @@ -92,7 +92,7 @@ void PairAmoeba::hal() factor_hal = special_hal[special_which]; if (factor_hal == 0.0) continue; j &= NEIGHMASK15; - + xr = xi - xred[j][0]; yr = yi - xred[j][1]; zr = zi - xred[j][2]; @@ -141,7 +141,7 @@ void PairAmoeba::hal() } ehal += e; - + // find the chain rule terms for derivative components de = de / rik; @@ -151,13 +151,13 @@ void PairAmoeba::hal() // increment the total van der Waals energy and derivatives // if jv < 0, trigger an error, needed H-bond partner is missing - + iv = ired2local[i]; jv = ired2local[j]; if (jv < 0) - error->one(FLERR,"AMOEBA hal cannot find H bond partner - " - "ghost comm is too short"); - + error->one(FLERR,"AMOEBA hal cannot find H bond partner - " + "ghost comm is too short"); + if (i == iv) { f[i][0] -= dedx; f[i][1] -= dedy; @@ -205,7 +205,7 @@ void PairAmoeba::hal() // energy = e // virial = 6-vec vir // NOTE: add tally function - + if (evflag) { } } diff --git a/src/AMOEBA/amoeba_induce.cpp b/src/AMOEBA/amoeba_induce.cpp index 312d71b3a8..65a2a8a55c 100644 --- a/src/AMOEBA/amoeba_induce.cpp +++ b/src/AMOEBA/amoeba_induce.cpp @@ -69,7 +69,7 @@ void PairAmoeba::induce() // set cutoffs, taper coeffs, and PME params // create qfac here, free at end of polar() - + if (use_ewald) { choose(POLAR_LONG); int nmine = p_kspace->nfft_owned; @@ -105,7 +105,7 @@ void PairAmoeba::induce() memory->create(usump,nlocal,3,"ameoba/induce:usump"); // get the electrostatic field due to permanent multipoles - + dfield0c(field,fieldp); // reverse comm to sum field,fieldp from ghost atoms to owned atoms @@ -119,11 +119,11 @@ void PairAmoeba::induce() for (i = 0; i < nlocal; i++) if (atom->tag[i] == 1) printf("AAA FIELD atom %d: field %g %g %g: fieldp %g %g %g\n", - atom->tag[i], - field[i][0],field[i][1],field[i][2], - fieldp[i][0],fieldp[i][1],fieldp[i][2]); + atom->tag[i], + field[i][0],field[i][1],field[i][2], + fieldp[i][0],fieldp[i][1],fieldp[i][2]); */ - + // set induced dipoles to polarizability times direct field for (i = 0; i < nlocal; i++) { @@ -144,17 +144,17 @@ void PairAmoeba::induce() for (i = 0; i < nlocal; i++) if (atom->tag[i] == 1) printf("AAA UDIR atom %d: udir %g %g %g: udirp %g %g %g\n", - atom->tag[i], - DEBYE*udir[i][0],DEBYE*udir[i][1],DEBYE*udir[i][2], - DEBYE*udirp[i][0],DEBYE*udirp[i][1],DEBYE*udirp[i][2]); + atom->tag[i], + DEBYE*udir[i][0],DEBYE*udir[i][1],DEBYE*udir[i][2], + DEBYE*udirp[i][0],DEBYE*udirp[i][1],DEBYE*udirp[i][2]); */ - + // get induced dipoles via the OPT extrapolation method // NOTE: any way to rewrite these loops to avoid allocating // uopt,uoptp with a optorder+1 dimension, just optorder ?? // since no need to store optorder+1 values after these loops - if (poltyp == OPT) { + if (poltyp == OPT) { for (i = 0; i < nlocal; i++) { for (j = 0; j < 3; j++) { uopt[i][0][j] = udir[i][j]; @@ -174,7 +174,7 @@ void PairAmoeba::induce() comm->reverse_comm(this); for (i = 0; i < nlocal; i++) { - itype = amtype[i]; + itype = amtype[i]; for (j = 0; j < 3; j++) { uopt[i][m][j] = polarity[itype] * field[i][j]; uoptp[i][m][j] = polarity[itype] * fieldp[i][j]; @@ -263,15 +263,15 @@ void PairAmoeba::induce() /* for (i = 0; i < nlocal; i++) if (atom->tag[i] == 1) - printf("UFIELD atom %d: uind %g %g %g uinp %g %g %g " - "field %g %g %g: fieldp %g %g %g\n", - atom->tag[i], - uind[i][0],uind[i][1],uind[i][2], - uinp[i][0],uinp[i][1],uinp[i][2], - field[i][0],field[i][1],field[i][2], - fieldp[i][0],fieldp[i][1],fieldp[i][2]); + printf("UFIELD atom %d: uind %g %g %g uinp %g %g %g " + "field %g %g %g: fieldp %g %g %g\n", + atom->tag[i], + uind[i][0],uind[i][1],uind[i][2], + uinp[i][0],uinp[i][1],uinp[i][2], + field[i][0],field[i][1],field[i][2], + fieldp[i][0],fieldp[i][1],fieldp[i][2]); */ - + // set initial conjugate gradient residual and conjugate vector for (i = 0; i < nlocal; i++) { @@ -295,7 +295,7 @@ void PairAmoeba::induce() cfstyle = RSD; comm->forward_comm(this); uscale0b(BUILD,rsd,rsdp,zrsd,zrsdp); - uscale0b(APPLY,rsd,rsdp,zrsd,zrsdp); + uscale0b(APPLY,rsd,rsdp,zrsd,zrsdp); crstyle = ZRSD; comm->reverse_comm(this); } @@ -312,15 +312,15 @@ void PairAmoeba::induce() /* for (i = 0; i < nlocal; i++) if (atom->tag[i] == 1) - printf("CONJ atom %d: rsd %g %g %g rsdp %g %g %g " - "conj %g %g %g: conjp %g %g %g\n", - atom->tag[i], - rsd[i][0],rsd[i][1],rsd[i][2], - rsdp[i][0],rsdp[i][1],rsdp[i][2], - conj[i][0],conj[i][1],conj[i][2], - conjp[i][0],conjp[i][1],conjp[i][2]); + printf("CONJ atom %d: rsd %g %g %g rsdp %g %g %g " + "conj %g %g %g: conjp %g %g %g\n", + atom->tag[i], + rsd[i][0],rsd[i][1],rsd[i][2], + rsdp[i][0],rsdp[i][1],rsdp[i][2], + conj[i][0],conj[i][1],conj[i][2], + conjp[i][0],conjp[i][1],conjp[i][2]); */ - + // conjugate gradient iteration of the mutual induced dipoles while (!done) { @@ -349,15 +349,15 @@ void PairAmoeba::induce() /* for (i = 0; i < nlocal; i++) - if (atom->tag[i] == 1) - printf("POST-COMM FIELD atom %d: field %g %g %g: fieldp %g %g %g\n", - atom->tag[i], - uind[i][0],uind[i][1],uind[i][2], - uinp[i][0],uinp[i][1],uinp[i][2], - field[i][0],field[i][1],field[i][2], - fieldp[i][0],fieldp[i][1],fieldp[i][2]); + if (atom->tag[i] == 1) + printf("POST-COMM FIELD atom %d: field %g %g %g: fieldp %g %g %g\n", + atom->tag[i], + uind[i][0],uind[i][1],uind[i][2], + uinp[i][0],uinp[i][1],uinp[i][2], + field[i][0],field[i][1],field[i][2], + fieldp[i][0],fieldp[i][1],fieldp[i][2]); */ - + for (i = 0; i < nlocal; i++) { for (j = 0; j < 3; j++) { uind[i][j] = vec[i][j]; @@ -409,17 +409,17 @@ void PairAmoeba::induce() /* for (i = 0; i < nlocal; i++) - if (atom->tag[i] == 1) - printf("POST-MPI UIND atom %d: uind %g %g %g: uinp %g %g %g\n", - atom->tag[i], - uind[i][0],uind[i][1],uind[i][2], - uinp[i][0],uinp[i][1],uinp[i][2]); + if (atom->tag[i] == 1) + printf("POST-MPI UIND atom %d: uind %g %g %g: uinp %g %g %g\n", + atom->tag[i], + uind[i][0],uind[i][1],uind[i][2], + uinp[i][0],uinp[i][1],uinp[i][2]); */ - + if (pcgprec) { cfstyle = RSD; comm->forward_comm(this); - uscale0b(APPLY,rsd,rsdp,zrsd,zrsdp); + uscale0b(APPLY,rsd,rsdp,zrsd,zrsdp); crstyle = ZRSD; comm->reverse_comm(this); } @@ -428,16 +428,16 @@ void PairAmoeba::induce() /* for (i = 0; i < nlocal; i++) - if (atom->tag[i] == 1) - printf("POST-PRECOND atom %d: rsd %g %g %g: rsdp %g %g %g " - "zrsd %g %g %g: zrsdp %g %g %g\n", - atom->tag[i], - rsd[i][0],rsd[i][1],rsd[i][2], - rsdp[i][0],rsdp[i][1],rsdp[i][2], - zrsd[i][0],zrsd[i][1],zrsd[i][2], - zrsdp[i][0],zrsdp[i][1],zrsdp[i][2]); + if (atom->tag[i] == 1) + printf("POST-PRECOND atom %d: rsd %g %g %g: rsdp %g %g %g " + "zrsd %g %g %g: zrsdp %g %g %g\n", + atom->tag[i], + rsd[i][0],rsd[i][1],rsd[i][2], + rsdp[i][0],rsdp[i][1],rsdp[i][2], + zrsd[i][0],zrsd[i][1],zrsd[i][2], + zrsdp[i][0],zrsdp[i][1],zrsdp[i][2]); */ - + b = 0.0; bp = 0.0; @@ -508,7 +508,7 @@ void PairAmoeba::induce() uind[i][0],uind[i][1],uind[i][2], uinp[i][0],uinp[i][1],uinp[i][2]); */ - + if (done) { for (i = 0; i < nlocal; i++) { term = pcgpeek * poli[i]; @@ -523,25 +523,25 @@ void PairAmoeba::induce() /* for (i = 0; i < nlocal; i++) - if (atom->tag[i] == 1) - printf("POST-DONE UIND atom %d: uind %g %g %g: uinp %g %g %g\n", - atom->tag[i], - DEBYE*uind[i][0],DEBYE*uind[i][1],DEBYE*uind[i][2], - DEBYE*uinp[i][0],DEBYE*uinp[i][1],DEBYE*uinp[i][2]); + if (atom->tag[i] == 1) + printf("POST-DONE UIND atom %d: uind %g %g %g: uinp %g %g %g\n", + atom->tag[i], + DEBYE*uind[i][0],DEBYE*uind[i][1],DEBYE*uind[i][2], + DEBYE*uinp[i][0],DEBYE*uinp[i][1],DEBYE*uinp[i][2]); */ } // terminate the calculation if dipoles failed to converge // NOTE: could make this an error - + if (iter >= maxiter || eps > epsold) if (me == 0) - error->warning(FLERR,"AMOEBA induced dipoles did not converge"); + error->warning(FLERR,"AMOEBA induced dipoles did not converge"); } // DEBUG output to dump file - if (UIND_DEBUG) + if (UIND_DEBUG) dump6(fp_uind,"id uindx uindy uindz uinpx uinpy uinpz",DEBYE,uind,uinp); // deallocation of arrays @@ -622,7 +622,7 @@ void PairAmoeba::ulspred() // derive normal equations corresponding to least squares fit // NOTE: check all N vs N-1 indices in code from here down - + } else if (polpred == LSQR) { double ***udalt = fixudalt->tstore; double ***upalt = fixupalt->tstore; @@ -722,7 +722,7 @@ void PairAmoeba::ufield0c(double **field, double **fieldp) // get the real space portion of the mutual field if (polar_rspace_flag) umutual2b(field,fieldp); - + // add the self-energy portion of the mutual field term = (4.0/3.0) * aewald*aewald*aewald / MY_PIS; @@ -731,13 +731,13 @@ void PairAmoeba::ufield0c(double **field, double **fieldp) field[i][j] += term*uind[i][j]; fieldp[i][j] += term*uinp[i][j]; } - + /* // DEBUG printf("UMUTUAL2B SELF i %d term %g aewald %g uind %g %g %g field %g %g %g\n", - atom->tag[i],term,aewald, - uind[i][0],uind[i][1],uind[i][2],field[i][0],field[i][1],field[i][2]); + atom->tag[i],term,aewald, + uind[i][0],uind[i][1],uind[i][2],field[i][0],field[i][1],field[i][2]); */ } } @@ -748,7 +748,7 @@ void PairAmoeba::ufield0c(double **field, double **fieldp) gradient induced dipole solver using a neighbor pair list ------------------------------------------------------------------------- */ -void PairAmoeba::uscale0b(int mode, double **rsd, double **rsdp, +void PairAmoeba::uscale0b(int mode, double **rsd, double **rsdp, double **zrsd, double **zrsdp) { int i,j,k,m,itype,jtype,iclass,jclass,igroup,jgroup; @@ -806,7 +806,7 @@ void PairAmoeba::uscale0b(int mode, double **rsd, double **rsdp, } // zero zrsd,zrsdp for ghost atoms only - + for (i = nlocal; i < nall; i++) { for (j = 0; j < 3; j++) { zrsd[i][j] = 0.0; @@ -824,7 +824,7 @@ void PairAmoeba::uscale0b(int mode, double **rsd, double **rsdp, for (jj = 0; jj < jnum; jj++) { j = jlist[jj]; - j &= NEIGHMASK15; + j &= NEIGHMASK15; m1 = pclist[0]; m2 = pclist[1]; @@ -866,7 +866,7 @@ void PairAmoeba::uscale0b(int mode, double **rsd, double **rsdp, itype = amtype[i]; iclass = amtype2class[itype]; igroup = amgroup[i]; - + jlist = firstneigh_precond[i]; jnum = numneigh_precond[i]; @@ -929,7 +929,7 @@ void PairAmoeba::uscale0b(int mode, double **rsd, double **rsdp, scale3 = factor_wscale * dmpik[2]; scale5 = factor_wscale * dmpik[4]; } - + polik = poli * polarity[jtype]; rr3 = scale3 * polik / (r*r2); rr5 = 3.0 * scale5 * polik / (r*r2*r2); @@ -942,16 +942,16 @@ void PairAmoeba::uscale0b(int mode, double **rsd, double **rsdp, pclist[5] = rr5*zr*zr - rr3; // DEBUG - + /* printf("PCLIST: ij %d %d: pc1-6 %g %g %g %g %g %g\n", - atom->tag[i],atom->tag[j], - pclist[0],pclist[1],pclist[2],pclist[3],pclist[4],pclist[5]); + atom->tag[i],atom->tag[j], + pclist[0],pclist[1],pclist[2],pclist[3],pclist[4],pclist[5]); printf(" AMOEBA: scale35 %g %g pdamp %g thole %g " - "pgamma %g facUscale %g damp %g\n", - scale3,scale5,pdamp[jtype],thole[jtype],pgamma,factor_uscale,damp); + "pgamma %g facUscale %g damp %g\n", + scale3,scale5,pdamp[jtype],thole[jtype],pgamma,factor_uscale,damp); */ - + pclist += 6; } } @@ -1023,7 +1023,7 @@ void PairAmoeba::umutual1(double **field, double **fieldp) double **fuind,**fuinp; double **fdip_phi1,**fdip_phi2,**fdip_sum_phi; double **dipfield1,**dipfield2; - + // return if the Ewald coefficient is zero if (aewald < 1.0e-6) return; @@ -1061,7 +1061,7 @@ void PairAmoeba::umutual1(double **field, double **fieldp) */ // gridpre = my portion of 4d grid in brick decomp w/ ghost values - + double ****gridpre = (double ****) ic_kspace->zero(); // map 2 values to grid @@ -1070,11 +1070,11 @@ void PairAmoeba::umutual1(double **field, double **fieldp) // pre-convolution operations including forward FFT // gridfft = my portion of complex 3d grid in FFT decomposition - + double *gridfft = ic_kspace->pre_convolution(); // --------------------- - // convolution operation + // convolution operation // --------------------- nxlo = ic_kspace->nxlo_fft; @@ -1093,7 +1093,7 @@ void PairAmoeba::umutual1(double **field, double **fieldp) term = qfac[m++]; gridfft[n] *= term; gridfft[n+1] *= term; - n += 2; + n += 2; } } } @@ -1104,7 +1104,7 @@ void PairAmoeba::umutual1(double **field, double **fieldp) double ****gridpost = (double ****) ic_kspace->post_convolution(); // get potential - + fphi_uind(gridpost,fdip_phi1,fdip_phi2,fdip_sum_phi); // printf ("fdip_phi1_uind %g %g %g %g %g %g %g %g %g %g\n", @@ -1138,9 +1138,9 @@ void PairAmoeba::umutual1(double **field, double **fieldp) for (i = 0; i < nlocal; i++) { for (j = 0; j < 3; j++) { - dipfield1[i][j] = a[j][0]*fdip_phi1[i][1] + + dipfield1[i][j] = a[j][0]*fdip_phi1[i][1] + a[j][1]*fdip_phi1[i][2] + a[j][2]*fdip_phi1[i][3]; - dipfield2[i][j] = a[j][0]*fdip_phi2[i][1] + + dipfield2[i][j] = a[j][0]*fdip_phi2[i][1] + a[j][1]*fdip_phi2[i][2] + a[j][2]*fdip_phi2[i][3]; } } @@ -1205,15 +1205,15 @@ void PairAmoeba::umutual2b(double **field, double **fieldp) fid[0] = tdipdip[0]*uindj[0] + tdipdip[1]*uindj[1] + tdipdip[2]*uindj[2]; fid[1] = tdipdip[1]*uindj[0] + tdipdip[3]*uindj[1] + tdipdip[4]*uindj[2]; fid[2] = tdipdip[2]*uindj[0] + tdipdip[4]*uindj[1] + tdipdip[5]*uindj[2]; - + fkd[0] = tdipdip[0]*uindi[0] + tdipdip[1]*uindi[1] + tdipdip[2]*uindi[2]; fkd[1] = tdipdip[1]*uindi[0] + tdipdip[3]*uindi[1] + tdipdip[4]*uindi[2]; fkd[2] = tdipdip[2]*uindi[0] + tdipdip[4]*uindi[1] + tdipdip[5]*uindi[2]; - + fip[0] = tdipdip[0]*uinpj[0] + tdipdip[1]*uinpj[1] + tdipdip[2]*uinpj[2]; fip[1] = tdipdip[1]*uinpj[0] + tdipdip[3]*uinpj[1] + tdipdip[4]*uinpj[2]; fip[2] = tdipdip[2]*uinpj[0] + tdipdip[4]*uinpj[1] + tdipdip[5]*uinpj[2]; - + fkp[0] = tdipdip[0]*uinpi[0] + tdipdip[1]*uinpi[1] + tdipdip[2]*uinpi[2]; fkp[1] = tdipdip[1]*uinpi[0] + tdipdip[3]*uinpi[1] + tdipdip[4]*uinpi[2]; fkp[2] = tdipdip[2]*uinpi[0] + tdipdip[4]*uinpi[1] + tdipdip[5]*uinpi[2]; @@ -1222,21 +1222,21 @@ void PairAmoeba::umutual2b(double **field, double **fieldp) /* if (atom->tag[i] == 1 || atom->tag[j] == 1) { - printf ("TDIPDIP ij %d %d: tdd %g %g %g %g %g %g\n", - atom->tag[i],atom->tag[j], - tdipdip[0],tdipdip[1],tdipdip[2], - tdipdip[3],tdipdip[4],tdipdip[5]); - printf ("FIDFKD ij %d %d: fid %g %g %g fkd %g %g %g\n", - atom->tag[i],atom->tag[j], - fid[0],fid[1],fid[2], - fkd[0],fkd[1],fkd[2]); - } - */ - + printf ("TDIPDIP ij %d %d: tdd %g %g %g %g %g %g\n", + atom->tag[i],atom->tag[j], + tdipdip[0],tdipdip[1],tdipdip[2], + tdipdip[3],tdipdip[4],tdipdip[5]); + printf ("FIDFKD ij %d %d: fid %g %g %g fkd %g %g %g\n", + atom->tag[i],atom->tag[j], + fid[0],fid[1],fid[2], + fkd[0],fkd[1],fkd[2]); + } + */ + tdipdip += 6; // increment the field at each site due to this interaction - + for (m = 0; m < 3; m++) { field[i][m] += fid[m]; field[j][m] += fkd[m]; @@ -1264,7 +1264,7 @@ void PairAmoeba::udirect1(double **field) double volterm,denom; double hsq,expterm; double term,pterm; - + // return if the Ewald coefficient is zero if (aewald < 1.0e-6) return; @@ -1282,7 +1282,7 @@ void PairAmoeba::udirect1(double **field) memory->create(fmp,nlocal,10,"ameoba/induce:fmp"); memory->create(cphi,nlocal,10,"ameoba/induce:cphi"); memory->create(fphi,nlocal,20,"ameoba/induce:fphi"); - + // FFT moduli pre-computations // set igrid for each atom and its B-spline coeffs @@ -1308,14 +1308,14 @@ void PairAmoeba::udirect1(double **field) cmp[i][8] = 2.0 * rpole[i][6]; cmp[i][9] = 2.0 * rpole[i][9]; } - + // convert Cartesian multipoles to fractional coordinates cmp_to_fmp(cmp,fmp); // gridpre = my portion of 3d grid in brick decomp w/ ghost values // zeroed by setup() - + double ***gridpre = (double ***) i_kspace->zero(); // map multipole moments to grid @@ -1324,11 +1324,11 @@ void PairAmoeba::udirect1(double **field) // pre-convolution operations including forward FFT // gridfft = my 1d portion of complex 3d grid in FFT decomp - + double *gridfft = i_kspace->pre_convolution(); // --------------------- - // convolution operation + // convolution operation // --------------------- nhalf1 = (nfft1+1) / 2; @@ -1341,28 +1341,28 @@ void PairAmoeba::udirect1(double **field) nyhi = i_kspace->nyhi_fft; nzlo = i_kspace->nzlo_fft; nzhi = i_kspace->nzhi_fft; - + m = n = 0; for (k = nzlo; k <= nzhi; k++) { for (j = nylo; j <= nyhi; j++) { for (i = nxlo; i <= nxhi; i++) { - r1 = (i >= nhalf1) ? i-nfft1 : i; - r2 = (j >= nhalf2) ? j-nfft2 : j; - r3 = (k >= nhalf3) ? k-nfft3 : k; - h1 = recip[0][0]*r1 + recip[0][1]*r2 + recip[0][2]*r3; // matvec - h2 = recip[1][0]*r1 + recip[1][1]*r2 + recip[1][2]*r3; - h3 = recip[2][0]*r1 + recip[2][1]*r2 + recip[2][2]*r3; - hsq = h1*h1 + h2*h2 + h3*h3; - term = -pterm * hsq; - expterm = 0.0; - if (term > -50.0 && hsq != 0.0) { - denom = volterm*hsq*bsmod1[i]*bsmod2[j]*bsmod3[k]; - expterm = exp(term) / denom; - } - qfac[m++] = expterm; + r1 = (i >= nhalf1) ? i-nfft1 : i; + r2 = (j >= nhalf2) ? j-nfft2 : j; + r3 = (k >= nhalf3) ? k-nfft3 : k; + h1 = recip[0][0]*r1 + recip[0][1]*r2 + recip[0][2]*r3; // matvec + h2 = recip[1][0]*r1 + recip[1][1]*r2 + recip[1][2]*r3; + h3 = recip[2][0]*r1 + recip[2][1]*r2 + recip[2][2]*r3; + hsq = h1*h1 + h2*h2 + h3*h3; + term = -pterm * hsq; + expterm = 0.0; + if (term > -50.0 && hsq != 0.0) { + denom = volterm*hsq*bsmod1[i]*bsmod2[j]*bsmod3[k]; + expterm = exp(term) / denom; + } + qfac[m++] = expterm; gridfft[n] *= expterm; gridfft[n+1] *= expterm; - n += 2; + n += 2; } } } @@ -1373,11 +1373,11 @@ void PairAmoeba::udirect1(double **field) double ***gridpost = (double ***) i_kspace->post_convolution(); // get potential - + fphi_mpole(gridpost,fphi); - // printf ("fphi %g %g %g %g %g %g %g %g %g %g %g %g\n", - // fphi[1][1],fphi[1][2],fphi[1][3],fphi[1][4],fphi[1][5], + // printf ("fphi %g %g %g %g %g %g %g %g %g %g %g %g\n", + // fphi[1][1],fphi[1][2],fphi[1][3],fphi[1][4],fphi[1][5], // fphi[1][6],fphi[1][7],fphi[1][8],fphi[1][9],fphi[1][10], // fphi[1][11],fphi[1][12]); @@ -1453,7 +1453,7 @@ void PairAmoeba::udirect2b(double **field, double **fieldp) firstneigh = list->firstneigh; // NOTE: doesn't this have a problem if aewald is tiny ?? - + aesq2 = 2.0 * aewald * aewald; aesq2n = 0.0; if (aewald > 0.0) aesq2n = 1.0 / (MY_PIS*aewald); @@ -1505,17 +1505,17 @@ void PairAmoeba::udirect2b(double **field, double **fieldp) printf("Atom 4 is in group %d\n",igroup); printf("Atoms in same group:"); for (int ig = 0; ig < atom->nlocal; ig++) - if (amgroup[ig] == igroup) printf(" %d",atom->tag[ig]); + if (amgroup[ig] == igroup) printf(" %d",atom->tag[ig]); printf("\n"); } */ - + // evaluate all sites within the cutoff distance for (jj = 0; jj < jnum; jj++) { jextra = jlist[jj]; j = jextra & NEIGHMASK15; - + xr = x[j][0] - x[i][0]; yr = x[j][1] - x[i][1]; zr = x[j][2] - x[i][2]; @@ -1525,36 +1525,36 @@ void PairAmoeba::udirect2b(double **field, double **fieldp) jtype = amtype[j]; jclass = amtype2class[jtype]; jgroup = amgroup[j]; - + if (amoeba) { - factor_wscale = special_polar_wscale[sbmask15(jextra)]; - if (igroup == jgroup) { - factor_pscale = special_polar_piscale[sbmask15(jextra)]; - factor_dscale = polar_dscale; - factor_uscale = polar_uscale; - } else { - factor_pscale = special_polar_pscale[sbmask15(jextra)]; - factor_dscale = factor_uscale = 1.0; - } - + factor_wscale = special_polar_wscale[sbmask15(jextra)]; + if (igroup == jgroup) { + factor_pscale = special_polar_piscale[sbmask15(jextra)]; + factor_dscale = polar_dscale; + factor_uscale = polar_uscale; + } else { + factor_pscale = special_polar_pscale[sbmask15(jextra)]; + factor_dscale = factor_uscale = 1.0; + } + } else if (hippo) { - factor_wscale = special_polar_wscale[sbmask15(jextra)]; - if (igroup == jgroup) { - factor_dscale = factor_pscale = special_polar_piscale[sbmask15(jextra)]; - factor_uscale = polar_uscale; - } else { - factor_dscale = factor_pscale = special_polar_pscale[sbmask15(jextra)]; - factor_uscale = 1.0; - } + factor_wscale = special_polar_wscale[sbmask15(jextra)]; + if (igroup == jgroup) { + factor_dscale = factor_pscale = special_polar_piscale[sbmask15(jextra)]; + factor_uscale = polar_uscale; + } else { + factor_dscale = factor_pscale = special_polar_pscale[sbmask15(jextra)]; + factor_uscale = 1.0; + } } // DEBUG /* if (atom->tag[i] == 4 || atom->tag[j] == 4) { - printf("PAIR ij %d %d ij group %d %d wpdu scale %g %g %g %g\n", - atom->tag[i],atom->tag[j],igroup,jgroup, - factor_wscale,factor_pscale,factor_dscale,factor_uscale); + printf("PAIR ij %d %d ij group %d %d wpdu scale %g %g %g %g\n", + atom->tag[i],atom->tag[j],igroup,jgroup, + factor_wscale,factor_pscale,factor_dscale,factor_uscale); } */ @@ -1574,7 +1574,7 @@ void PairAmoeba::udirect2b(double **field, double **fieldp) qkyy = rpole[j][8]; qkyz = rpole[j][9]; qkzz = rpole[j][12]; - + // intermediates involving moments and separation distance dir = dix*xr + diy*yr + diz*zr; @@ -1587,7 +1587,7 @@ void PairAmoeba::udirect2b(double **field, double **fieldp) qky = qkxy*xr + qkyy*yr + qkyz*zr; qkz = qkxz*xr + qkyz*yr + qkzz*zr; qkr = qkx*xr + qky*yr + qkz*zr; - + // calculate the real space Ewald error function terms ralpha = aewald * r; @@ -1599,7 +1599,7 @@ void PairAmoeba::udirect2b(double **field, double **fieldp) aefac = aesq2 * aefac; bn[m] = (bfac*bn[m-1]+aefac*exp2a) * rr2; } - + // find the field components for Thole polarization damping if (amoeba) { @@ -1633,24 +1633,24 @@ void PairAmoeba::udirect2b(double **field, double **fieldp) bcn[0] = bn[1] - (1.0-scalek*scale3)*rr3; bcn[1] = bn[2] - (1.0-scalek*scale5)*rr5; bcn[2] = bn[3] - (1.0-scalek*scale7)*rr7; - fid[0] = -xr*(bcn[0]*ck-bcn[1]*dkr+bcn[2]*qkr) - + fid[0] = -xr*(bcn[0]*ck-bcn[1]*dkr+bcn[2]*qkr) - bcn[0]*dkx + 2.0*bcn[1]*qkx; - fid[1] = -yr*(bcn[0]*ck-bcn[1]*dkr+bcn[2]*qkr) - + fid[1] = -yr*(bcn[0]*ck-bcn[1]*dkr+bcn[2]*qkr) - bcn[0]*dky + 2.0*bcn[1]*qky; - fid[2] = -zr*(bcn[0]*ck-bcn[1]*dkr+bcn[2]*qkr) - + fid[2] = -zr*(bcn[0]*ck-bcn[1]*dkr+bcn[2]*qkr) - bcn[0]*dkz + 2.0*bcn[1]*qkz; - fkd[0] = xr*(bcn[0]*ci+bcn[1]*dir+bcn[2]*qir) - + fkd[0] = xr*(bcn[0]*ci+bcn[1]*dir+bcn[2]*qir) - bcn[0]*dix - 2.0*bcn[1]*qix; - fkd[1] = yr*(bcn[0]*ci+bcn[1]*dir+bcn[2]*qir) - + fkd[1] = yr*(bcn[0]*ci+bcn[1]*dir+bcn[2]*qir) - bcn[0]*diy - 2.0*bcn[1]*qiy; - fkd[2] = zr*(bcn[0]*ci+bcn[1]*dir+bcn[2]*qir) - + fkd[2] = zr*(bcn[0]*ci+bcn[1]*dir+bcn[2]*qir) - bcn[0]*diz - 2.0*bcn[1]*qiz; - + scalek = factor_pscale; bcn[0] = bn[1] - (1.0-scalek*scale3)*rr3; bcn[1] = bn[2] - (1.0-scalek*scale5)*rr5; bcn[2] = bn[3] - (1.0-scalek*scale7)*rr7; - fip[0] = -xr*(bcn[0]*ck-bcn[1]*dkr+bcn[2]*qkr) - + fip[0] = -xr*(bcn[0]*ck-bcn[1]*dkr+bcn[2]*qkr) - bcn[0]*dkx + 2.0*bcn[1]*qkx; fip[1] = -yr*(bcn[0]*ck-bcn[1]*dkr+bcn[2]*qkr) - bcn[0]*dky + 2.0*bcn[1]*qky; @@ -1662,7 +1662,7 @@ void PairAmoeba::udirect2b(double **field, double **fieldp) bcn[0]*diy - 2.0*bcn[1]*qiy; fkp[2] = zr*(bcn[0]*ci+bcn[1]*dir+bcn[2]*qir) - bcn[0]*diz - 2.0*bcn[1]*qiz; - + // find terms needed later to compute mutual polarization if (poltyp != DIRECT) { @@ -1681,7 +1681,7 @@ void PairAmoeba::udirect2b(double **field, double **fieldp) scalek = factor_uscale; bcn[0] = bn[1] - (1.0-scalek*scale3)*rr3; bcn[1] = bn[2] - (1.0-scalek*scale5)*rr5; - + neighptr[n++] = j; tdipdip[ndip++] = -bcn[0] + bcn[1]*xr*xr; tdipdip[ndip++] = bcn[1]*xr*yr; @@ -1690,7 +1690,7 @@ void PairAmoeba::udirect2b(double **field, double **fieldp) tdipdip[ndip++] = bcn[1]*yr*zr; tdipdip[ndip++] = -bcn[0] + bcn[1]*zr*zr; } - + // find the field components for charge penetration damping } else if (hippo) { @@ -1698,7 +1698,7 @@ void PairAmoeba::udirect2b(double **field, double **fieldp) alphak = palpha[jclass]; valk = pval[j]; dampdir(r,alphai,alphak,dmpi,dmpk); - + scalek = factor_dscale; rr3i = bn[1] - (1.0-scalek*dmpi[2])*rr3; rr5i = bn[2] - (1.0-scalek*dmpi[4])*rr5; @@ -1741,7 +1741,7 @@ void PairAmoeba::udirect2b(double **field, double **fieldp) rr3i*diy - 2.0*rr5i*qiy; fkp[2] = zr*(rr3*corei + rr3i*vali + rr5i*dir + rr7i*qir) - rr3i*diz - 2.0*rr5i*qiz; - + // find terms needed later to compute mutual polarization if (poltyp != DIRECT) { @@ -1751,16 +1751,16 @@ void PairAmoeba::udirect2b(double **field, double **fieldp) rr3ik = bn[1] - (1.0-scalek*dmpik[2])*rr3; rr5ik = bn[2] - (1.0-scalek*dmpik[4])*rr5; - // DEBUG + // DEBUG + + /* + if (atom->tag[i] == 1 || atom->tag[j] == 1) + printf ("DAMPMUT ij %d %d: bn12 %g %g dmpik-01234 %g %g %g %g %g\n", + atom->tag[i],atom->tag[j], + bn[1],bn[2], + dmpik[0],dmpik[1],dmpik[2],dmpik[3],dmpik[4]); + */ - /* - if (atom->tag[i] == 1 || atom->tag[j] == 1) - printf ("DAMPMUT ij %d %d: bn12 %g %g dmpik-01234 %g %g %g %g %g\n", - atom->tag[i],atom->tag[j], - bn[1],bn[2], - dmpik[0],dmpik[1],dmpik[2],dmpik[3],dmpik[4]); - */ - neighptr[n++] = j; tdipdip[ndip++] = -rr3ik + rr5ik*xr*xr; tdipdip[ndip++] = rr5ik*xr*yr; @@ -1770,9 +1770,9 @@ void PairAmoeba::udirect2b(double **field, double **fieldp) tdipdip[ndip++] = -rr3ik + rr5ik*zr*zr; } } - + // increment the field at each site due to this interaction - + for (m = 0; m < 3; m++) { field[i][m] += fid[m]; field[j][m] += fkd[m]; @@ -1823,9 +1823,9 @@ void PairAmoeba::dampmut(double r, double alphai, double alphak, double *dmpik) if (diff < eps) { dampi4 = dampi2 * dampi2; dampi5 = dampi2 * dampi3; - dmpik[2] = 1.0 - (1.0 + dampi + 0.5*dampi2 + + dmpik[2] = 1.0 - (1.0 + dampi + 0.5*dampi2 + 7.0*dampi3/48.0 + dampi4/48.0)*expi; - dmpik[4] = 1.0 - (1.0 + dampi + 0.5*dampi2 + dampi3/6.0 + + dmpik[4] = 1.0 - (1.0 + dampi + 0.5*dampi2 + dampi3/6.0 + dampi4/24.0 + dampi5/144.0)*expi; } else { dampk2 = dampk * dampk; @@ -1836,12 +1836,12 @@ void PairAmoeba::dampmut(double r, double alphai, double alphak, double *dmpik) termk = alphai2 / (alphai2-alphak2); termi2 = termi * termi; termk2 = termk * termk; - dmpik[2] = 1.0 - termi2*(1.0+dampi+0.5*dampi2)*expi - - termk2*(1.0+dampk+0.5*dampk2)*expk - + dmpik[2] = 1.0 - termi2*(1.0+dampi+0.5*dampi2)*expi - + termk2*(1.0+dampk+0.5*dampk2)*expk - 2.0*termi2*termk*(1.0+dampi)*expi - 2.0*termk2*termi*(1.0+dampk)*expk; - dmpik[4] = 1.0 - termi2*(1.0+dampi+0.5*dampi2 + dampi3/6.0)*expi - - termk2*(1.0+dampk+0.5*dampk2 + dampk3/6.00)*expk - - 2.0*termi2*termk *(1.0+dampi+dampi2/3.0)*expi - + dmpik[4] = 1.0 - termi2*(1.0+dampi+0.5*dampi2 + dampi3/6.0)*expi - + termk2*(1.0+dampk+0.5*dampk2 + dampk3/6.00)*expk - + 2.0*termi2*termk *(1.0+dampi+dampi2/3.0)*expi - 2.0*termk2*termi *(1.0+dampk+dampk2/3.0)*expk; } } @@ -1852,7 +1852,7 @@ void PairAmoeba::dampmut(double r, double alphai, double alphak, double *dmpik) function for powers of the interatomic distance ------------------------------------------------------------------------- */ -void PairAmoeba::dampdir(double r, double alphai, double alphak, +void PairAmoeba::dampdir(double r, double alphai, double alphak, double *dmpi, double *dmpk) { double eps,diff; @@ -1917,7 +1917,7 @@ void PairAmoeba::cholesky(int nvar, double *a, double *b) a--; b--; - + // Cholesky factorization to reduce A to (L)(D)(L transpose) // L has a unit diagonal; store 1.0/D on the diagonal of A @@ -1927,19 +1927,19 @@ void PairAmoeba::cholesky(int nvar, double *a, double *b) if (i != 1) { ij = i; for (j = 1; j <= im; j++) { - r = a[ij]; - if (j != 1) { - ik = i; - jk = j; - jm = j - 1; - for (k = 1; k <= jm; k++) { - r = r - a[ik]*a[jk]; - ik = nvar - k + ik; - jk = nvar - k + jk; - } - } - a[ij] = r; - ij = nvar - j + ij; + r = a[ij]; + if (j != 1) { + ik = i; + jk = j; + jm = j - 1; + for (k = 1; k <= jm; k++) { + r = r - a[ik]*a[jk]; + ik = nvar - k + ik; + jk = nvar - k + jk; + } + } + a[ij] = r; + ij = nvar - j + ij; } } @@ -1948,12 +1948,12 @@ void PairAmoeba::cholesky(int nvar, double *a, double *b) kk = 1; ik = i; for (k = 1; k <= im; k++) { - s = a[ik]; - t = s * a[kk]; - a[ik] = t; - r = r - s*t; - ik = nvar - k + ik; - kk = nvar - k + 1 + kk; + s = a[ik]; + t = s * a[kk]; + a[ik] = t; + r = r - s*t; + ik = nvar - k + ik; + kk = nvar - k + 1 + kk; } } @@ -1969,8 +1969,8 @@ void PairAmoeba::cholesky(int nvar, double *a, double *b) im = i - 1; r = b[i]; for (k = 1; k <= im; k++) { - r = r - b[k]*a[ik]; - ik = nvar - k + ik; + r = r - b[k]*a[ik]; + ik = nvar - k + ik; } b[i] = r; } @@ -1986,8 +1986,8 @@ void PairAmoeba::cholesky(int nvar, double *a, double *b) im = i + 1; ki = ii + 1; for (k = im; k <= nvar; k++) { - r = r - a[ki]*b[k]; - ki = ki + 1; + r = r - a[ki]*b[k]; + ki = ki + 1; } } b[i] = r; diff --git a/src/AMOEBA/amoeba_kspace.cpp b/src/AMOEBA/amoeba_kspace.cpp index b73ff8e018..094afd4241 100644 --- a/src/AMOEBA/amoeba_kspace.cpp +++ b/src/AMOEBA/amoeba_kspace.cpp @@ -61,7 +61,7 @@ void PairAmoeba::moduli() int maxfft = MAX(nfft1,nfft2); maxfft = MAX(maxfft,nfft3); - + double *array = new double[bsorder]; double *bsarray = new double[maxfft]; @@ -79,7 +79,7 @@ void PairAmoeba::moduli() dftmod(bsmod3,bsarray,nfft3,bsorder); // perform deallocation of local arrays - + delete [] array; delete [] bsarray; } @@ -104,7 +104,7 @@ void PairAmoeba::bspline(double x, int n, double *c) /*for (k = 2; k < n; k++) { denom = 1.0 / (k-1); c[k] = x * c[k-1] * denom; - for (i = 0; i < k-1; i++) + for (i = 0; i < k-1; i++) c[k-i] = ((x+i)*c[k-i-1] + (k-i-x)*c[k-i]) * denom; c[0] = (1.0-x) * c[0] * denom; }*/ @@ -148,15 +148,15 @@ void PairAmoeba::dftmod(double *bsmod, double *bsarray, int nfft, int order) bsmod[i] = sum1*sum1 + sum2*sum2; //printf("BSMOD AAA i %d bsmod %g\n",i,bsmod[i]); } - + // fix for exponential Euler spline interpolation failure eps = 1.0e-7; if (bsmod[0] < eps) bsmod[0] = 0.5 * bsmod[1]; - for (i = 1; i < nfft-1; i++) + for (i = 1; i < nfft-1; i++) if (bsmod[i] < eps) bsmod[i] = 0.5 * (bsmod[i-1] + bsmod[i+1]); if (bsmod[nfft-1] < eps) bsmod[nfft-1] = 0.5 * bsmod[nfft-2]; - + // compute and apply the optimal zeta coefficient jcut = 50; @@ -170,14 +170,14 @@ void PairAmoeba::dftmod(double *bsmod, double *bsarray, int nfft, int order) sum2 = 1.0; factor = MY_PI * k / nfft; for (j = 1; j <= jcut; j++) { - arg = factor / (factor + MY_PI*j); - sum1 += pow(arg,order); - sum2 += pow(arg,order2); + arg = factor / (factor + MY_PI*j); + sum1 += pow(arg,order); + sum2 += pow(arg,order2); } for (j = 1; j <= jcut; j++) { - arg = factor / (factor - MY_PI*j); - sum1 += pow(arg,order); - sum2 += pow(arg,order2); + arg = factor / (factor - MY_PI*j); + sum1 += pow(arg,order); + sum2 += pow(arg,order2); } zeta = sum2 / sum1; } @@ -197,7 +197,7 @@ void PairAmoeba::bspline_fill() double xi,yi,zi; double w,fr,eps; double lamda[3]; - + int nlocal = atom->nlocal; double **x = atom->x; @@ -258,7 +258,7 @@ void PairAmoeba::bsplgen(double w, double **thetai) double denom; level = 4; - + // initialization to get to 2nd order recursion bsbuild[1][1] = w; @@ -278,7 +278,7 @@ void PairAmoeba::bsplgen(double w, double **thetai) bsbuild[i-1][i-1] = denom * w * bsbuild[k-1][k-1]; for (j = 1; j <= i-2; j++) { bsbuild[i-j-1][i-1] = denom * - ((w+j)*bsbuild[i-j-2][k-1] + (i-j-w)*bsbuild[i-j-1][k-1]); + ((w+j)*bsbuild[i-j-2][k-1] + (i-j-w)*bsbuild[i-j-1][k-1]); } bsbuild[0][i-1] = denom * (1.0-w) * bsbuild[0][k-1]; } @@ -290,7 +290,7 @@ void PairAmoeba::bsplgen(double w, double **thetai) for (int i = bsorder-1; i >= 2; i--) bsbuild[i-1][k-1] = bsbuild[i-2][k-1] - bsbuild[i-1][k-1]; bsbuild[0][k-1] = -bsbuild[0][k-1]; - + // get coefficients for the B-spline second derivative if (level == 4) { @@ -351,7 +351,7 @@ void PairAmoeba::cmp_to_fmp(double **cmp, double **fmp) for (j = 1; j < 4; j++) { fmp[i][j] = 0.0; for (k = 1; k < 4; k++) - fmp[i][j] += ctf[j][k] * cmp[i][k]; + fmp[i][j] += ctf[j][k] * cmp[i][k]; } for (j = 4; j < 10; j++) { fmp[i][j] = 0.0; @@ -439,12 +439,12 @@ void PairAmoeba::fphi_to_cphi(double **fphi, double **cphi) for (j = 1; j < 4; j++) { cphi[i][j] = 0.0; for (k = 1; k < 4; k++) - cphi[i][j] += ftc[j][k] * fphi[i][k]; + cphi[i][j] += ftc[j][k] * fphi[i][k]; } for (j = 4; j < 10; j++) { cphi[i][j] = 0.0; for (k = 4; k < 10; k++) - cphi[i][j] += ftc[j][k] * fphi[i][k]; + cphi[i][j] += ftc[j][k] * fphi[i][k]; } } } @@ -530,9 +530,9 @@ void PairAmoeba::grid_mpole(double **fmp, double ***grid) // spread the permanent multipole moments onto the grid int nlocal = atom->nlocal; - + for (m = 0; m < nlocal; m++) { - + k = igrid[m][2] - nlpts; for (kb = 0; kb < bsorder; kb++) { v0 = thetai3[m][kb][0]; @@ -541,43 +541,43 @@ void PairAmoeba::grid_mpole(double **fmp, double ***grid) j = igrid[m][1] - nlpts; for (jb = 0; jb < bsorder; jb++) { - u0 = thetai2[m][jb][0]; - u1 = thetai2[m][jb][1]; - u2 = thetai2[m][jb][2]; - term0 = fmp[m][0]*u0*v0 + fmp[m][2]*u1*v0 + fmp[m][3]*u0*v1 + - fmp[m][5]*u2*v0 + fmp[m][6]*u0*v2 + fmp[m][9]*u1*v1; - term1 = fmp[m][1]*u0*v0 + fmp[m][7]*u1*v0 + fmp[m][8]*u0*v1; - term2 = fmp[m][4]*u0*v0; - - i = igrid[m][0] - nlpts; - for (ib = 0; ib < bsorder; ib++) { - t0 = thetai1[m][ib][0]; - t1 = thetai1[m][ib][1]; - t2 = thetai1[m][ib][2]; - grid[k][j][i] += term0*t0 + term1*t1 + term2*t2; - - // if (m == 0) { - // int istencil = kb*bsorder*bsorder + jb*bsorder + ib + 1; - // printf("GRIDMPOLE iStencil %d atomID %d igrid %d %d %d " - // "ibjbkb %d %d %d ijk %d %d %d " - // "th1 %g %g %g th2 %g %g %g th3 %g %g %g " - // "fmp0-9 %e %e %e %e %e %e %e %e %e %e " + u0 = thetai2[m][jb][0]; + u1 = thetai2[m][jb][1]; + u2 = thetai2[m][jb][2]; + term0 = fmp[m][0]*u0*v0 + fmp[m][2]*u1*v0 + fmp[m][3]*u0*v1 + + fmp[m][5]*u2*v0 + fmp[m][6]*u0*v2 + fmp[m][9]*u1*v1; + term1 = fmp[m][1]*u0*v0 + fmp[m][7]*u1*v0 + fmp[m][8]*u0*v1; + term2 = fmp[m][4]*u0*v0; + + i = igrid[m][0] - nlpts; + for (ib = 0; ib < bsorder; ib++) { + t0 = thetai1[m][ib][0]; + t1 = thetai1[m][ib][1]; + t2 = thetai1[m][ib][2]; + grid[k][j][i] += term0*t0 + term1*t1 + term2*t2; + + // if (m == 0) { + // int istencil = kb*bsorder*bsorder + jb*bsorder + ib + 1; + // printf("GRIDMPOLE iStencil %d atomID %d igrid %d %d %d " + // "ibjbkb %d %d %d ijk %d %d %d " + // "th1 %g %g %g th2 %g %g %g th3 %g %g %g " + // "fmp0-9 %e %e %e %e %e %e %e %e %e %e " // "term012 %e %e %e " - // "gridvalue %g\n", - // istencil,atom->tag[m], - // igrid[m][0],igrid[m][1],igrid[m][2], - // ib,jb,kb,i,j,k, - // t0,t1,t2,u0,u1,u2,v0,v1,v2, - // fmp[m][0],fmp[m][1],fmp[m][2], - // fmp[m][3],fmp[m][4],fmp[m][5], - // fmp[m][6],fmp[m][7],fmp[m][8],fmp[m][9], + // "gridvalue %g\n", + // istencil,atom->tag[m], + // igrid[m][0],igrid[m][1],igrid[m][2], + // ib,jb,kb,i,j,k, + // t0,t1,t2,u0,u1,u2,v0,v1,v2, + // fmp[m][0],fmp[m][1],fmp[m][2], + // fmp[m][3],fmp[m][4],fmp[m][5], + // fmp[m][6],fmp[m][7],fmp[m][8],fmp[m][9], // term0,term1,term2, - // term0*t0 + term1*t1 + term2*t2); - // } - - i++; - } - j++; + // term0*t0 + term1*t1 + term2*t2); + // } + + i++; + } + j++; } k++; } @@ -608,9 +608,9 @@ void PairAmoeba::fphi_mpole(double ***grid, double **fphi) int nrpts = bsorder - nlpts - 1; // extract the permanent multipole field at each site - + int nlocal = atom->nlocal; - + for (m = 0; m < nlocal; m++) { tuv000 = 0.0; tuv001 = 0.0; @@ -649,39 +649,39 @@ void PairAmoeba::fphi_mpole(double ***grid, double **fphi) tu21 = 0.0; tu12 = 0.0; tu03 = 0.0; - + j = igrid[m][1] - nlpts; for (jb = 0; jb < bsorder; jb++) { - u0 = thetai2[m][jb][0]; - u1 = thetai2[m][jb][1]; - u2 = thetai2[m][jb][2]; - u3 = thetai2[m][jb][3]; - t0 = 0.0; - t1 = 0.0; - t2 = 0.0; - t3 = 0.0; + u0 = thetai2[m][jb][0]; + u1 = thetai2[m][jb][1]; + u2 = thetai2[m][jb][2]; + u3 = thetai2[m][jb][3]; + t0 = 0.0; + t1 = 0.0; + t2 = 0.0; + t3 = 0.0; - i = igrid[m][0] - nlpts; - for (ib = 0; ib < bsorder; ib++) { - tq = grid[k][j][i]; - t0 += tq*thetai1[m][ib][0]; - t1 += tq*thetai1[m][ib][1]; - t2 += tq*thetai1[m][ib][2]; - t3 += tq*thetai1[m][ib][3]; - i++; - } + i = igrid[m][0] - nlpts; + for (ib = 0; ib < bsorder; ib++) { + tq = grid[k][j][i]; + t0 += tq*thetai1[m][ib][0]; + t1 += tq*thetai1[m][ib][1]; + t2 += tq*thetai1[m][ib][2]; + t3 += tq*thetai1[m][ib][3]; + i++; + } - tu00 += t0*u0; - tu10 += t1*u0; - tu01 += t0*u1; - tu20 += t2*u0; - tu11 += t1*u1; - tu02 += t0*u2; - tu30 += t3*u0; - tu21 += t2*u1; - tu12 += t1*u2; - tu03 += t0*u3; - j++; + tu00 += t0*u0; + tu10 += t1*u0; + tu01 += t0*u1; + tu20 += t2*u0; + tu11 += t1*u1; + tu02 += t0*u2; + tu30 += t3*u0; + tu21 += t2*u1; + tu12 += t1*u2; + tu03 += t0*u3; + j++; } tuv000 += tu00*v0; @@ -749,7 +749,7 @@ void PairAmoeba::grid_uind(double **fuind, double **fuinp, double ****grid) // put the induced dipole moments onto the grid int nlocal = atom->nlocal; - + for (m = 0; m < nlocal; m++) { k = igrid[m][2] - nlpts; @@ -759,23 +759,23 @@ void PairAmoeba::grid_uind(double **fuind, double **fuinp, double ****grid) j = igrid[m][1] - nlpts; for (jb = 0; jb < bsorder; jb++) { - u0 = thetai2[m][jb][0]; - u1 = thetai2[m][jb][1]; - term01 = fuind[m][1]*u1*v0 + fuind[m][2]*u0*v1; - term11 = fuind[m][0]*u0*v0; - term02 = fuinp[m][1]*u1*v0 + fuinp[m][2]*u0*v1; - term12 = fuinp[m][0]*u0*v0; + u0 = thetai2[m][jb][0]; + u1 = thetai2[m][jb][1]; + term01 = fuind[m][1]*u1*v0 + fuind[m][2]*u0*v1; + term11 = fuind[m][0]*u0*v0; + term02 = fuinp[m][1]*u1*v0 + fuinp[m][2]*u0*v1; + term12 = fuinp[m][0]*u0*v0; - i = igrid[m][0] - nlpts; - for (ib = 0; ib < bsorder; ib++) { - t0 = thetai1[m][ib][0]; - t1 = thetai1[m][ib][1]; - grid[k][j][i][0] += term01*t0 + term11*t1; - grid[k][j][i][1] += term02*t0 + term12*t1; + i = igrid[m][0] - nlpts; + for (ib = 0; ib < bsorder; ib++) { + t0 = thetai1[m][ib][0]; + t1 = thetai1[m][ib][1]; + grid[k][j][i][0] += term01*t0 + term11*t1; + grid[k][j][i][1] += term02*t0 + term12*t1; //printf("gridcheck %g %g \n",grid[k][j][i][0],grid[k][j][i][0]); - i++; - } - j++; + i++; + } + j++; } k++; } @@ -783,12 +783,12 @@ void PairAmoeba::grid_uind(double **fuind, double **fuinp, double ****grid) } /* ---------------------------------------------------------------------- - fphi_uind = induced potential from grid + fphi_uind = induced potential from grid fphi_uind extracts the induced dipole potential from the particle mesh Ewald grid ------------------------------------------------------------------------- */ void PairAmoeba::fphi_uind(double ****grid, double **fdip_phi1, - double **fdip_phi2, double **fdip_sum_phi) + double **fdip_phi2, double **fdip_sum_phi) { int i,j,k,m,ib,jb,kb; double v0,v1,v2,v3; @@ -820,7 +820,7 @@ void PairAmoeba::fphi_uind(double ****grid, double **fdip_phi1, // extract the permanent multipole field at each site int nlocal = atom->nlocal; - + for (m = 0; m < nlocal; m++) { tuv100_1 = 0.0; tuv010_1 = 0.0; @@ -892,60 +892,60 @@ void PairAmoeba::fphi_uind(double ****grid, double **fdip_phi1, j = igrid[m][1] - nlpts; for (jb = 0; jb < bsorder; jb++) { - u0 = thetai2[m][jb][0]; - u1 = thetai2[m][jb][1]; - u2 = thetai2[m][jb][2]; - u3 = thetai2[m][jb][3]; - t0_1 = 0.0; - t1_1 = 0.0; - t2_1 = 0.0; - t0_2 = 0.0; - t1_2 = 0.0; - t2_2 = 0.0; - t3 = 0.0; + u0 = thetai2[m][jb][0]; + u1 = thetai2[m][jb][1]; + u2 = thetai2[m][jb][2]; + u3 = thetai2[m][jb][3]; + t0_1 = 0.0; + t1_1 = 0.0; + t2_1 = 0.0; + t0_2 = 0.0; + t1_2 = 0.0; + t2_2 = 0.0; + t3 = 0.0; - i = igrid[m][0] - nlpts; - for (ib = 0; ib < bsorder; ib++) { - tq_1 = grid[k][j][i][0]; - tq_2 = grid[k][j][i][1]; - t0_1 += tq_1*thetai1[m][ib][0]; - t1_1 += tq_1*thetai1[m][ib][1]; - t2_1 += tq_1*thetai1[m][ib][2]; - t0_2 += tq_2*thetai1[m][ib][0]; - t1_2 += tq_2*thetai1[m][ib][1]; - t2_2 += tq_2*thetai1[m][ib][2]; - t3 += (tq_1+tq_2)*thetai1[m][ib][3]; - i++; - } + i = igrid[m][0] - nlpts; + for (ib = 0; ib < bsorder; ib++) { + tq_1 = grid[k][j][i][0]; + tq_2 = grid[k][j][i][1]; + t0_1 += tq_1*thetai1[m][ib][0]; + t1_1 += tq_1*thetai1[m][ib][1]; + t2_1 += tq_1*thetai1[m][ib][2]; + t0_2 += tq_2*thetai1[m][ib][0]; + t1_2 += tq_2*thetai1[m][ib][1]; + t2_2 += tq_2*thetai1[m][ib][2]; + t3 += (tq_1+tq_2)*thetai1[m][ib][3]; + i++; + } - tu00_1 += t0_1*u0; - tu10_1 += t1_1*u0; - tu01_1 += t0_1*u1; - tu20_1 += t2_1*u0; - tu11_1 += t1_1*u1; - tu02_1 += t0_1*u2; - tu00_2 += t0_2*u0; - tu10_2 += t1_2*u0; - tu01_2 += t0_2*u1; - tu20_2 += t2_2*u0; - tu11_2 += t1_2*u1; - tu02_2 += t0_2*u2; - t0 = t0_1 + t0_2; - t1 = t1_1 + t1_2; - t2 = t2_1 + t2_2; - tu00 += t0*u0; - tu10 += t1*u0; - tu01 += t0*u1; - tu20 += t2*u0; - tu11 += t1*u1; - tu02 += t0*u2; - tu30 += t3*u0; - tu21 += t2*u1; - tu12 += t1*u2; - tu03 += t0*u3; - j++; + tu00_1 += t0_1*u0; + tu10_1 += t1_1*u0; + tu01_1 += t0_1*u1; + tu20_1 += t2_1*u0; + tu11_1 += t1_1*u1; + tu02_1 += t0_1*u2; + tu00_2 += t0_2*u0; + tu10_2 += t1_2*u0; + tu01_2 += t0_2*u1; + tu20_2 += t2_2*u0; + tu11_2 += t1_2*u1; + tu02_2 += t0_2*u2; + t0 = t0_1 + t0_2; + t1 = t1_1 + t1_2; + t2 = t2_1 + t2_2; + tu00 += t0*u0; + tu10 += t1*u0; + tu01 += t0*u1; + tu20 += t2*u0; + tu11 += t1*u1; + tu02 += t0*u2; + tu30 += t3*u0; + tu21 += t2*u1; + tu12 += t1*u2; + tu03 += t0*u3; + j++; } - + tuv100_1 += tu10_1*v0; tuv010_1 += tu01_1*v0; tuv001_1 += tu00_1*v1; @@ -997,7 +997,7 @@ void PairAmoeba::fphi_uind(double ****grid, double **fdip_phi1, fdip_phi1[m][7] = tuv110_1; fdip_phi1[m][8] = tuv101_1; fdip_phi1[m][9] = tuv011_1; - + fdip_phi2[m][0] = 0.0; fdip_phi2[m][1] = tuv100_2; fdip_phi2[m][2] = tuv010_2; @@ -1008,7 +1008,7 @@ void PairAmoeba::fphi_uind(double ****grid, double **fdip_phi1, fdip_phi2[m][7] = tuv110_2; fdip_phi2[m][8] = tuv101_2; fdip_phi2[m][9] = tuv011_2; - + fdip_sum_phi[m][0] = tuv000; fdip_sum_phi[m][1] = tuv100; fdip_sum_phi[m][2] = tuv010; @@ -1049,7 +1049,7 @@ void PairAmoeba::grid_disp(double ***grid) // put the dispersion sites onto the grid int nlocal = atom->nlocal; - + for (m = 0; m < nlocal; m++) { itype = amtype[m]; iclass = amtype2class[itype]; @@ -1057,19 +1057,19 @@ void PairAmoeba::grid_disp(double ***grid) k = igrid[m][2] - nlpts; for (kb = 0; kb < bsorder; kb++) { v0 = thetai3[m][kb][0] * csix[iclass]; - + j = igrid[m][1] - nlpts; for (jb = 0; jb < bsorder; jb++) { - u0 = thetai2[m][jb][0]; - term = v0 * u0; - - i = igrid[m][0] - nlpts; - for (ib = 0; ib < bsorder; ib++) { - t0 = thetai1[m][ib][0]; - grid[k][j][i] += term*t0; - i++; - } - j++; + u0 = thetai2[m][jb][0]; + term = v0 * u0; + + i = igrid[m][0] - nlpts; + for (ib = 0; ib < bsorder; ib++) { + t0 = thetai1[m][ib][0]; + grid[k][j][i] += term*t0; + i++; + } + j++; } k++; } @@ -1091,19 +1091,19 @@ void PairAmoeba::kewald() double size,slope; // use_ewald is for multipole and induce and polar - + if (!use_ewald) aeewald = apewald = 0.0; - + if (use_ewald) { if (!aeewald_key) aeewald = ewaldcof(ewaldcut); - + if (!apewald_key) { apewald = aeewald; size = MIN(domain->xprd,domain->yprd); size = MIN(size,domain->zprd); if (size < 6.0) { - slope = (1.0-apewald) / 2.0; - apewald += slope*(6.0-size); + slope = (1.0-apewald) / 2.0; + apewald += slope*(6.0-size); } } @@ -1122,14 +1122,14 @@ void PairAmoeba::kewald() while (!factorable(nefft2)) nefft2++; while (!factorable(nefft3)) nefft3++; } - + // use_dewald is for dispersion - + if (!use_dewald) adewald = 0.0; - + if (use_dewald) { if (!adewald_key) adewald = ewaldcof(dispcut); - + if (!dpmegrid_key) { delta = 1.0e-8; ddens = 0.8; @@ -1140,7 +1140,7 @@ void PairAmoeba::kewald() // increase grid sizes until factorable by 2,3,5 // NOTE: also worry about satisfying Tinker minfft ? - + while (!factorable(ndfft1)) ndfft1++; while (!factorable(ndfft2)) ndfft3++; while (!factorable(ndfft3)) ndfft3++; @@ -1160,12 +1160,12 @@ void PairAmoeba::kewald() if (use_dewald) nfft1 = MAX(nfft1,ndfft1); if (use_dewald) nfft2 = MAX(nfft2,ndfft2); if (use_dewald) nfft3 = MAX(nfft3,ndfft3); - + bsordermax = 0; if (use_ewald) bsordermax = bseorder; if (use_ewald) bsordermax = MAX(bsordermax,bsporder); if (use_dewald) bsordermax = MAX(bsordermax,bsdorder); - + memory->create(bsmod1,nfft1,"amoeba:bsmod1"); memory->create(bsmod2,nfft2,"amoeba:bsmod2"); memory->create(bsmod3,nfft3,"amoeba:bsmod3"); @@ -1203,7 +1203,7 @@ double PairAmoeba::ewaldcof(double cutoff) } // use a binary search to refine the coefficient - + k = i + 60; xlo = 0.0; xhi = x; @@ -1214,7 +1214,7 @@ double PairAmoeba::ewaldcof(double cutoff) if (ratio >= eps) xlo = x; else xhi = x; } - + return x; } diff --git a/src/AMOEBA/amoeba_multipole.cpp b/src/AMOEBA/amoeba_multipole.cpp index a2c3a41231..66fe18ead2 100644 --- a/src/AMOEBA/amoeba_multipole.cpp +++ b/src/AMOEBA/amoeba_multipole.cpp @@ -111,7 +111,7 @@ void PairAmoeba::multipole() qizz = rpole[i][12]; cii = ci*ci; dii = dix*dix + diy*diy + diz*diz; - qii = 2.0*(qixy*qixy+qixz*qixz+qiyz*qiyz) + + qii = 2.0*(qixy*qixy+qixz*qixz+qiyz*qiyz) + qixx*qixx + qiyy*qiyy + qizz*qizz; e = fterm * (cii + term*(dii/3.0+2.0*term*qii/5.0)); empole += e; @@ -214,7 +214,7 @@ void PairAmoeba::multipole_real() //int count = 0; //int imin,imax; - + // compute the real space portion of the Ewald summation for (ii = 0; ii < inum; ii++) { @@ -257,7 +257,7 @@ void PairAmoeba::multipole_real() if (r2 > off2) continue; // DEBUG - + //imin = MIN(atom->tag[i],atom->tag[j]); //imax = MAX(atom->tag[i],atom->tag[j]); @@ -292,7 +292,7 @@ void PairAmoeba::multipole_real() qik = qix*qkx + qiy*qky + qiz*qkz; diqk = dix*qkx + diy*qky + diz*qkz; dkqi = dkx*qix + dky*qiy + dkz*qiz; - qiqk = 2.0*(qixy*qkxy+qixz*qkxz+qiyz*qkyz) + + qiqk = 2.0*(qixy*qkxy+qixz*qkxz+qiyz*qkyz) + qixx*qkxx + qiyy*qkyy + qizz*qkzz; // additional intermediates involving moments and distance @@ -339,11 +339,11 @@ void PairAmoeba::multipole_real() dkqirx = dkqiz*yr - dkqiy*zr; dkqiry = dkqix*zr - dkqiz*xr; dkqirz = dkqiy*xr - dkqix*yr; - dqikx = diy*qkz - diz*qky + dky*qiz - dkz*qiy - + dqikx = diy*qkz - diz*qky + dky*qiz - dkz*qiy - 2.0*(qixy*qkxz+qiyy*qkyz+qiyz*qkzz - qixz*qkxy-qiyz*qkyy-qizz*qkyz); - dqiky = diz*qkx - dix*qkz + dkz*qix - dkx*qiz - + dqiky = diz*qkx - dix*qkz + dkz*qix - dkx*qiz - 2.0*(qixz*qkxx+qiyz*qkxy+qizz*qkxz - qixx*qkxz-qixy*qkyz-qixz*qkzz); - dqikz = dix*qky - diy*qkx + dkx*qiy - dky*qix - + dqikz = dix*qky - diy*qkx + dkx*qiy - dky*qix - 2.0*(qixx*qkxy+qixy*qkyy+qixz*qkyz - qixy*qkxx-qiyy*qkxy-qiyz*qkxz); // get reciprocal distance terms for this interaction @@ -377,11 +377,11 @@ void PairAmoeba::multipole_real() alphak = palpha[jclass]; valk = pval[j]; - /* - printf("HIPPO MPOLE ij %d %d: pcore/alpha/val I %g %g %g: J %g %g %g\n", - atom->tag[i],atom->tag[j],corei,alphai,vali,corek,alphak,valk); - */ - + /* + printf("HIPPO MPOLE ij %d %d: pcore/alpha/val I %g %g %g: J %g %g %g\n", + atom->tag[i],atom->tag[j],corei,alphai,vali,corek,alphak,valk); + */ + term1 = corei*corek; term1i = corek*vali; term2i = corek*dir; @@ -412,16 +412,16 @@ void PairAmoeba::multipole_real() rr11ik = bn[5] - (1.0-scalek*dmpij[10])*rr11; rr1 = bn[0] - (1.0-scalek)*rr1; rr3 = bn[1] - (1.0-scalek)*rr3; - e = term1*rr1 + term4ik*rr7ik + term5ik*rr9ik + - term1i*rr1i + term1k*rr1k + term1ik*rr1ik + - term2i*rr3i + term2k*rr3k + term2ik*rr3ik + + e = term1*rr1 + term4ik*rr7ik + term5ik*rr9ik + + term1i*rr1i + term1k*rr1k + term1ik*rr1ik + + term2i*rr3i + term2k*rr3k + term2ik*rr3ik + term3i*rr5i + term3k*rr5k + term3ik*rr5ik; // find damped multipole intermediates for force and torque - de = term1*rr3 + term4ik*rr9ik + term5ik*rr11ik + - term1i*rr3i + term1k*rr3k + term1ik*rr3ik + - term2i*rr5i + term2k*rr5k + term2ik*rr5ik + + de = term1*rr3 + term4ik*rr9ik + term5ik*rr11ik + + term1i*rr3i + term1k*rr3k + term1ik*rr3ik + + term2i*rr5i + term2k*rr5k + term2ik*rr5ik + term3i*rr7i + term3k*rr7k + term3ik*rr7ik; term1 = -corek*rr3i - valk*rr3ik + dkr*rr5ik - qkr*rr7ik; term2 = corei*rr3k + vali*rr3ik + dir*rr5ik + qir*rr7ik; @@ -467,44 +467,44 @@ void PairAmoeba::multipole_real() count++; if (imin == 68 && imax == 1021) { - //printf("AAA %d %d %16.12g\n",imin,imax,e); - printf("AAA %d: %d %d: %d %d: %d: %16.12g\n", - me,atom->tag[i],atom->tag[j],i,j,atom->nlocal,e); - printf("XYZ %g %g %g: %g %g %g\n", - x[i][0],x[i][1],x[i][2],x[j][0],x[j][1],x[j][2]); + //printf("AAA %d %d %16.12g\n",imin,imax,e); + printf("AAA %d: %d %d: %d %d: %d: %16.12g\n", + me,atom->tag[i],atom->tag[j],i,j,atom->nlocal,e); + printf("XYZ %g %g %g: %g %g %g\n", + x[i][0],x[i][1],x[i][2],x[j][0],x[j][1],x[j][2]); } */ - + /* if (atom->tag[i] == 1 || atom->tag[j] == 1) { - printf("MPOLE %d %d %d: %15.12g %15.12g %g\n", - atom->tag[i],atom->tag[j],j,r,e,factor_mpole); - printf(" BN: %g %g %g: %g %g %g\n",bn[0],bn[1],bn[2],bn[3],bn[4],bn[5]); + printf("MPOLE %d %d %d: %15.12g %15.12g %g\n", + atom->tag[i],atom->tag[j],j,r,e,factor_mpole); + printf(" BN: %g %g %g: %g %g %g\n",bn[0],bn[1],bn[2],bn[3],bn[4],bn[5]); } */ - + // compute the force components for this interaction - frcx = de*xr + term1*dix + term2*dkx + term3*(diqkx-dkqix) + + frcx = de*xr + term1*dix + term2*dkx + term3*(diqkx-dkqix) + term4*qix + term5*qkx + term6*(qixk+qkxi); - frcy = de*yr + term1*diy + term2*dky + term3*(diqky-dkqiy) + + frcy = de*yr + term1*diy + term2*dky + term3*(diqky-dkqiy) + term4*qiy + term5*qky + term6*(qiyk+qkyi); - frcz = de*zr + term1*diz + term2*dkz + term3*(diqkz-dkqiz) + + frcz = de*zr + term1*diz + term2*dkz + term3*(diqkz-dkqiz) + term4*qiz + term5*qkz + term6*(qizk+qkzi); // compute the torque components for this interaction - ttmi[0] = -rr3*dikx + term1*dirx + term3*(dqikx+dkqirx) - + ttmi[0] = -rr3*dikx + term1*dirx + term3*(dqikx+dkqirx) - term4*qirx - term6*(qikrx+qikx); - ttmi[1] = -rr3*diky + term1*diry + term3*(dqiky+dkqiry) - + ttmi[1] = -rr3*diky + term1*diry + term3*(dqiky+dkqiry) - term4*qiry - term6*(qikry+qiky); - ttmi[2] = -rr3*dikz + term1*dirz + term3*(dqikz+dkqirz) - + ttmi[2] = -rr3*dikz + term1*dirz + term3*(dqikz+dkqirz) - term4*qirz - term6*(qikrz+qikz); - ttmk[0] = rr3*dikx + term2*dkrx - term3*(dqikx+diqkrx) - + ttmk[0] = rr3*dikx + term2*dkrx - term3*(dqikx+diqkrx) - term5*qkrx - term6*(qkirx-qikx); - ttmk[1] = rr3*diky + term2*dkry - term3*(dqiky+diqkry) - + ttmk[1] = rr3*diky + term2*dkry - term3*(dqiky+diqkry) - term5*qkry - term6*(qkiry-qiky); - ttmk[2] = rr3*dikz + term2*dkrz - term3*(dqikz+diqkrz) - + ttmk[2] = rr3*dikz + term2*dkrz - term3*(dqikz+diqkrz) - term5*qkrz - term6*(qkirz-qikz); // increment force-based gradient and torque on first site @@ -544,7 +544,7 @@ void PairAmoeba::multipole_real() // energy = e // virial = 6-vec vir // NOTE: add tally function - + if (evflag) { } } @@ -558,7 +558,7 @@ void PairAmoeba::multipole_real() // resolve site torques then increment forces and virial for (i = 0; i < nlocal; i++) { - torque2force(i,tq[i],fix,fiy,fiz,f); + torque2force(i,tq[i],fix,fiy,fiz,f); iz = zaxis2local[i]; ix = xaxis2local[i]; @@ -575,12 +575,12 @@ void PairAmoeba::multipole_real() ziy = x[iy][2] - x[i][2]; vxx = xix*fix[0] + xiy*fiy[0] + xiz*fiz[0]; - vxy = 0.5 * (yix*fix[0] + yiy*fiy[0] + yiz*fiz[0] + + vxy = 0.5 * (yix*fix[0] + yiy*fiy[0] + yiz*fiz[0] + xix*fix[1] + xiy*fiy[1] + xiz*fiz[1]); - vxz = 0.5 * (zix*fix[0] + ziy*fiy[0] + ziz*fiz[0] + + vxz = 0.5 * (zix*fix[0] + ziy*fiy[0] + ziz*fiz[0] + xix*fix[2] + xiy*fiy[2] + xiz*fiz[2]); vyy = yix*fix[1] + yiy*fiy[1] + yiz*fiz[1]; - vyz = 0.5 * (zix*fix[1] + ziy*fiy[1] + ziz*fiz[1] + + vyz = 0.5 * (zix*fix[1] + ziy*fiy[1] + ziz*fiz[1] + yix*fix[2] + yiy*fiy[2] + yiz*fiz[2]); vzz = zix*fix[2] + ziy*fiy[2] + ziz*fiz[2]; @@ -643,10 +643,10 @@ void PairAmoeba::multipole_kspace() double volbox = domain->prd[0] * domain->prd[1] * domain->prd[2]; felec = electric / am_dielectric; - + // perform dynamic allocation of arrays // NOTE: just do this one time? - + memory->create(cmp,nlocal,10,"ameoba/mpole:cmp"); memory->create(fmp,nlocal,10,"ameoba/mpole:fmp"); memory->create(cphi,nlocal,10,"ameoba/mpole:cphi"); @@ -692,11 +692,11 @@ void PairAmoeba::multipole_kspace() // pre-convolution operations including forward FFT // gridfft = my portion of complex 3d grid in FFT decomp as 1d vector - + double *gridfft = m_kspace->pre_convolution(); // --------------------- - // convolution operation + // convolution operation // --------------------- // zero virial accumulation variables @@ -718,7 +718,7 @@ void PairAmoeba::multipole_kspace() pterm = pow((MY_PI/aewald),2.0); volterm = MY_PI * volbox; - + // printf("bsmod1 %e %e %e %e %e %e \n",bsmod1[0],bsmod1[1],bsmod1[2],bsmod1[3],bsmod1[4],bsmod1[5]); // printf("bsmod2 %e %e %e %e %e %e \n",bsmod2[0],bsmod2[1],bsmod2[2],bsmod2[3],bsmod2[4],bsmod2[5]); // printf("bsmod3 %e %e %e %e %e %e \n",bsmod3[0],bsmod3[1],bsmod3[2],bsmod3[3],bsmod3[4],bsmod3[5]); @@ -727,33 +727,33 @@ void PairAmoeba::multipole_kspace() for (k = nzlo; k <= nzhi; k++) { for (j = nylo; j <= nyhi; j++) { for (i = nxlo; i <= nxhi; i++) { - r1 = (i >= nhalf1) ? i-nfft1 : i; - r2 = (j >= nhalf2) ? j-nfft2 : j; - r3 = (k >= nhalf3) ? k-nfft3 : k; + r1 = (i >= nhalf1) ? i-nfft1 : i; + r2 = (j >= nhalf2) ? j-nfft2 : j; + r3 = (k >= nhalf3) ? k-nfft3 : k; //printf("ijk %i %i %i r1r2r3 %f %f %f \n",i,j,k,r1,r2,r3); - h1 = recip[0][0]*r1 + recip[0][1]*r2 + recip[0][2]*r3; // matvec - h2 = recip[1][0]*r1 + recip[1][1]*r2 + recip[1][2]*r3; - h3 = recip[2][0]*r1 + recip[2][1]*r2 + recip[2][2]*r3; - hsq = h1*h1 + h2*h2 + h3*h3; - term = -pterm * hsq; - expterm = 0.0; - if (term > -50.0 && hsq != 0.0) { - denom = volterm*hsq*bsmod1[i]*bsmod2[j]*bsmod3[k]; - expterm = exp(term) / denom; + h1 = recip[0][0]*r1 + recip[0][1]*r2 + recip[0][2]*r3; // matvec + h2 = recip[1][0]*r1 + recip[1][1]*r2 + recip[1][2]*r3; + h3 = recip[2][0]*r1 + recip[2][1]*r2 + recip[2][2]*r3; + hsq = h1*h1 + h2*h2 + h3*h3; + term = -pterm * hsq; + expterm = 0.0; + if (term > -50.0 && hsq != 0.0) { + denom = volterm*hsq*bsmod1[i]*bsmod2[j]*bsmod3[k]; + expterm = exp(term) / denom; //printf("bsmod %e %e %e expterm %e \n",bsmod1[i],bsmod2[j],bsmod3[k],expterm); - struc2 = gridfft[n]*gridfft[n] + gridfft[n+1]*gridfft[n+1]; - eterm = 0.5 * felec * expterm * struc2; - vterm = (2.0/hsq) * (1.0-term) * eterm; - vxx += h1*h1*vterm - eterm; - vyy += h2*h2*vterm - eterm; - vzz += h3*h3*vterm - eterm; - vxy += h1*h2*vterm; - vxz += h1*h3*vterm; - vyz += h2*h3*vterm; - } + struc2 = gridfft[n]*gridfft[n] + gridfft[n+1]*gridfft[n+1]; + eterm = 0.5 * felec * expterm * struc2; + vterm = (2.0/hsq) * (1.0-term) * eterm; + vxx += h1*h1*vterm - eterm; + vyy += h2*h2*vterm - eterm; + vzz += h3*h3*vterm - eterm; + vxy += h1*h2*vterm; + vxz += h1*h3*vterm; + vyz += h2*h3*vterm; + } gridfft[n] *= expterm; gridfft[n+1] *= expterm; - n += 2; + n += 2; } } } @@ -773,7 +773,7 @@ void PairAmoeba::multipole_kspace() double ***gridpost = (double ***) m_kspace->post_convolution(); // get potential - + fphi_mpole(gridpost,fphi); //printf("fphi %e %e %e %e \n",fphi[0][0],fphi[0][1],fphi[0][2],fphi[0][3]); @@ -813,41 +813,41 @@ void PairAmoeba::multipole_kspace() } empole += 0.5*e; //printf("mpole_force %g %g %g \n", f[0][0], f[0][1], f[0][2]); - + // augment the permanent multipole virial contributions for (i = 0; i < nlocal; i++) { - vxx = vxx - cmp[i][1]*cphi[i][1] - 2.0*cmp[i][4]*cphi[i][4] - + vxx = vxx - cmp[i][1]*cphi[i][1] - 2.0*cmp[i][4]*cphi[i][4] - cmp[i][7]*cphi[i][7] - cmp[i][8]*cphi[i][8]; - vxy = vxy - 0.5*(cmp[i][2]*cphi[i][1]+cmp[i][1]*cphi[i][2]) - - (cmp[i][4]+cmp[i][5])*cphi[i][7] - 0.5*cmp[i][7]*(cphi[i][4]+cphi[i][5]) - + vxy = vxy - 0.5*(cmp[i][2]*cphi[i][1]+cmp[i][1]*cphi[i][2]) - + (cmp[i][4]+cmp[i][5])*cphi[i][7] - 0.5*cmp[i][7]*(cphi[i][4]+cphi[i][5]) - 0.5*(cmp[i][8]*cphi[i][9]+cmp[i][9]*cphi[i][8]); - vxz = vxz - 0.5*(cmp[i][3]*cphi[i][1]+cmp[i][1]*cphi[i][3]) - - (cmp[i][4]+cmp[i][6])*cphi[i][8] - 0.5*cmp[i][8]*(cphi[i][4]+cphi[i][6]) - + vxz = vxz - 0.5*(cmp[i][3]*cphi[i][1]+cmp[i][1]*cphi[i][3]) - + (cmp[i][4]+cmp[i][6])*cphi[i][8] - 0.5*cmp[i][8]*(cphi[i][4]+cphi[i][6]) - 0.5*(cmp[i][7]*cphi[i][9]+cmp[i][9]*cphi[i][7]); - vyy = vyy - cmp[i][2]*cphi[i][2] - 2.0*cmp[i][5]*cphi[i][5] - + vyy = vyy - cmp[i][2]*cphi[i][2] - 2.0*cmp[i][5]*cphi[i][5] - cmp[i][7]*cphi[i][7] - cmp[i][9]*cphi[i][9]; - vyz = vyz - 0.5*(cmp[i][3]*cphi[i][2]+cmp[i][2]*cphi[i][3]) - - (cmp[i][5]+cmp[i][6])*cphi[i][9] - 0.5*cmp[i][9]*(cphi[i][5]+cphi[i][6]) - + vyz = vyz - 0.5*(cmp[i][3]*cphi[i][2]+cmp[i][2]*cphi[i][3]) - + (cmp[i][5]+cmp[i][6])*cphi[i][9] - 0.5*cmp[i][9]*(cphi[i][5]+cphi[i][6]) - 0.5*(cmp[i][7]*cphi[i][8]+cmp[i][8]*cphi[i][7]); - vzz = vzz - cmp[i][3]*cphi[i][3] - 2.0*cmp[i][6]*cphi[i][6] - + vzz = vzz - cmp[i][3]*cphi[i][3] - 2.0*cmp[i][6]*cphi[i][6] - cmp[i][8]*cphi[i][8] - cmp[i][9]*cphi[i][9]; } // resolve site torques then increment forces and virial for (i = 0; i < nlocal; i++) { - tem[0] = cmp[i][3]*cphi[i][2] - cmp[i][2]*cphi[i][3] + - 2.0*(cmp[i][6]-cmp[i][5])*cphi[i][9] + - cmp[i][8]*cphi[i][7] + cmp[i][9]*cphi[i][5] - + tem[0] = cmp[i][3]*cphi[i][2] - cmp[i][2]*cphi[i][3] + + 2.0*(cmp[i][6]-cmp[i][5])*cphi[i][9] + + cmp[i][8]*cphi[i][7] + cmp[i][9]*cphi[i][5] - cmp[i][7]*cphi[i][8] - cmp[i][9]*cphi[i][6]; - tem[1] = cmp[i][1]*cphi[i][3] - cmp[i][3]*cphi[i][1] + - 2.0*(cmp[i][4]-cmp[i][6])*cphi[i][8] + - cmp[i][7]*cphi[i][9] + cmp[i][8]*cphi[i][6] - + tem[1] = cmp[i][1]*cphi[i][3] - cmp[i][3]*cphi[i][1] + + 2.0*(cmp[i][4]-cmp[i][6])*cphi[i][8] + + cmp[i][7]*cphi[i][9] + cmp[i][8]*cphi[i][6] - cmp[i][8]*cphi[i][4] - cmp[i][9]*cphi[i][7]; - tem[2] = cmp[i][2]*cphi[i][1] - cmp[i][1]*cphi[i][2] + - 2.0*(cmp[i][5]-cmp[i][4])*cphi[i][7] + - cmp[i][7]*cphi[i][4] + cmp[i][9]*cphi[i][8] - + tem[2] = cmp[i][2]*cphi[i][1] - cmp[i][1]*cphi[i][2] + + 2.0*(cmp[i][5]-cmp[i][4])*cphi[i][7] + + cmp[i][7]*cphi[i][4] + cmp[i][9]*cphi[i][8] - cmp[i][7]*cphi[i][5] - cmp[i][8]*cphi[i][9]; torque2force(i,tem,fix,fiy,fiz,f); @@ -867,16 +867,16 @@ void PairAmoeba::multipole_kspace() ziy = x[iy][2] - x[i][2]; vxx += xix*fix[0] + xiy*fiy[0] + xiz*fiz[0]; - vxy += 0.5*(yix*fix[0] + yiy*fiy[0] + yiz*fiz[0] + + vxy += 0.5*(yix*fix[0] + yiy*fiy[0] + yiz*fiz[0] + xix*fix[1] + xiy*fiy[1] + xiz*fiz[1]); - vxz += 0.5*(zix*fix[0] + ziy*fiy[0] + ziz*fiz[0] + + vxz += 0.5*(zix*fix[0] + ziy*fiy[0] + ziz*fiz[0] + xix*fix[2] + xiy*fiy[2] + xiz*fiz[2]); vyy += yix*fix[1] + yiy*fiy[1] + yiz*fiz[1]; - vyz += 0.5*(zix*fix[1] + ziy*fiy[1] + ziz*fiz[1] + + vyz += 0.5*(zix*fix[1] + ziy*fiy[1] + ziz*fiz[1] + yix*fix[2] + yiy*fiy[2] + yiz*fiz[2]); vzz += zix*fix[2] + ziy*fiy[2] + ziz*fiz[2]; } - + // increment total internal virial tensor components virmpole[0] += vxx; @@ -947,7 +947,7 @@ void PairAmoeba::damppole(double r, int rorder, double alphai, double alphak, dmpi[2] = 1.0 - (1.0 + dampi + 0.5*dampi2)*expi; dmpi[4] = 1.0 - (1.0 + dampi + 0.5*dampi2 + dampi3/6.0)*expi; dmpi[6] = 1.0 - (1.0 + dampi + 0.5*dampi2 + dampi3/6.0 + dampi4/30.0)*expi; - dmpi[8] = 1.0 - (1.0 + dampi + 0.5*dampi2 + dampi3/6.0 + + dmpi[8] = 1.0 - (1.0 + dampi + 0.5*dampi2 + dampi3/6.0 + 4.0*dampi4/105.0 + dampi5/210.0)*expi; if (diff < eps) { dmpk[0] = dmpi[0]; @@ -964,7 +964,7 @@ void PairAmoeba::damppole(double r, int rorder, double alphai, double alphak, dmpk[2] = 1.0 - (1.0 + dampk + 0.5*dampk2)*expk; dmpk[4] = 1.0 - (1.0 + dampk + 0.5*dampk2 + dampk3/6.0)*expk; dmpk[6] = 1.0 - (1.0 + dampk + 0.5*dampk2 + dampk3/6.0 + dampk4/30.0)*expk; - dmpk[8] = 1.0 - (1.0 + dampk + 0.5*dampk2 + dampk3/6.0 + + dmpk[8] = 1.0 - (1.0 + dampk + 0.5*dampk2 + dampk3/6.0 + 4.0*dampk4/105.0 + dampk5/210.0)*expk; } @@ -973,21 +973,21 @@ void PairAmoeba::damppole(double r, int rorder, double alphai, double alphak, if (diff < eps) { dampi6 = dampi3 * dampi3; dampi7 = dampi3 * dampi4; - dmpik[0] = 1.0 - (1.0 + 11.0*dampi/16.0 + 3.0*dampi2/16.0 + + dmpik[0] = 1.0 - (1.0 + 11.0*dampi/16.0 + 3.0*dampi2/16.0 + dampi3/48.0)*expi; - dmpik[2] = 1.0 - (1.0 + dampi + 0.5*dampi2 + + dmpik[2] = 1.0 - (1.0 + dampi + 0.5*dampi2 + 7.0*dampi3/48.0 + dampi4/48.0)*expi; - dmpik[4] = 1.0 - (1.0 + dampi + 0.5*dampi2 + dampi3/6.0 + + dmpik[4] = 1.0 - (1.0 + dampi + 0.5*dampi2 + dampi3/6.0 + dampi4/24.0 + dampi5/144.0)*expi; - dmpik[6] = 1.0 - (1.0 + dampi + 0.5*dampi2 + dampi3/6.0 + + dmpik[6] = 1.0 - (1.0 + dampi + 0.5*dampi2 + dampi3/6.0 + dampi4/24.0 + dampi5/120.0 + dampi6/720.0)*expi; - dmpik[8] = 1.0 - (1.0 + dampi + 0.5*dampi2 + dampi3/6.0 + - dampi4/24.0 + dampi5/120.0 + dampi6/720.0 + + dmpik[8] = 1.0 - (1.0 + dampi + 0.5*dampi2 + dampi3/6.0 + + dampi4/24.0 + dampi5/120.0 + dampi6/720.0 + dampi7/5040.0)*expi; if (rorder >= 11) { dampi8 = dampi4 * dampi4; - dmpik[10] = 1.0 - (1.0 + dampi + 0.5*dampi2 + dampi3/6.0 + - dampi4/24.0 + dampi5/120.0 + dampi6/720.0 + + dmpik[10] = 1.0 - (1.0 + dampi + 0.5*dampi2 + dampi3/6.0 + + dampi4/24.0 + dampi5/120.0 + dampi6/720.0 + dampi7/5040.0 + dampi8/45360.0)*expi; } @@ -998,41 +998,41 @@ void PairAmoeba::damppole(double r, int rorder, double alphai, double alphak, termk = alphai2 / (alphai2-alphak2); termi2 = termi * termi; termk2 = termk * termk; - dmpik[0] = 1.0 - termi2*(1.0 + 2.0*termk + 0.5*dampi)*expi - + dmpik[0] = 1.0 - termi2*(1.0 + 2.0*termk + 0.5*dampi)*expi - termk2*(1.0 + 2.0*termi + 0.5*dampk)*expk; dmpik[2] = 1.0 - termi2*(1.0+dampi+0.5*dampi2)*expi - termk2*(1.0+dampk+0.5*dampk2)*expk - 2.0*termi2*termk*(1.0+dampi)*expi - 2.0*termk2*termi*(1.0+dampk)*expk; - dmpik[4] = 1.0 - termi2*(1.0 + dampi + 0.5*dampi2 + dampi3/6.0)*expi - - termk2*(1.0 + dampk + 0.5*dampk2 + dampk3/6.0)*expk - - 2.0*termi2*termk*(1.0 + dampi + dampi2/3.0)*expi - + dmpik[4] = 1.0 - termi2*(1.0 + dampi + 0.5*dampi2 + dampi3/6.0)*expi - + termk2*(1.0 + dampk + 0.5*dampk2 + dampk3/6.0)*expk - + 2.0*termi2*termk*(1.0 + dampi + dampi2/3.0)*expi - 2.0*termk2*termi*(1.0 + dampk + dampk2/3.0)*expk; - dmpik[6] = 1.0 - termi2*(1.0 + dampi + 0.5*dampi2 + - dampi3/6.0 + dampi4/30.0)*expi - - termk2*(1.0 + dampk + 0.5*dampk2 + dampk3/6.0 + dampk4/30.0)*expk - - 2.0*termi2*termk*(1.0 + dampi + 2.0*dampi2/5.0 + dampi3/15.0)*expi - + dmpik[6] = 1.0 - termi2*(1.0 + dampi + 0.5*dampi2 + + dampi3/6.0 + dampi4/30.0)*expi - + termk2*(1.0 + dampk + 0.5*dampk2 + dampk3/6.0 + dampk4/30.0)*expk - + 2.0*termi2*termk*(1.0 + dampi + 2.0*dampi2/5.0 + dampi3/15.0)*expi - 2.0*termk2*termi*(1.0 + dampk + 2.0*dampk2/5.0 + dampk3/15.0)*expk; - dmpik[8] = 1.0 - termi2*(1.0 + dampi + 0.5*dampi2 + dampi3/6.0 + - 4.0*dampi4/105.0 + dampi5/210.0)*expi - - termk2*(1.0 + dampk + 0.5*dampk2 + dampk3/6.0 + - 4.0*dampk4/105.0 + dampk5/210.0)*expk - - 2.0*termi2*termk*(1.0 + dampi + 3.0*dampi2/7.0 + - 2.0*dampi3/21.0 + dampi4/105.0)*expi - - 2.0*termk2*termi*(1.0 + dampk + 3.0*dampk2/7.0 + + dmpik[8] = 1.0 - termi2*(1.0 + dampi + 0.5*dampi2 + dampi3/6.0 + + 4.0*dampi4/105.0 + dampi5/210.0)*expi - + termk2*(1.0 + dampk + 0.5*dampk2 + dampk3/6.0 + + 4.0*dampk4/105.0 + dampk5/210.0)*expk - + 2.0*termi2*termk*(1.0 + dampi + 3.0*dampi2/7.0 + + 2.0*dampi3/21.0 + dampi4/105.0)*expi - + 2.0*termk2*termi*(1.0 + dampk + 3.0*dampk2/7.0 + 2.0*dampk3/21.0 + dampk4/105.0)*expk; - + if (rorder >= 11) { dampi6 = dampi3 * dampi3; dampk6 = dampk3 * dampk3; - dmpik[10] = 1.0 - termi2*(1.0 + dampi + 0.5*dampi2 + dampi3/6.0 + - 5.0*dampi4/126.0 + 2.0*dampi5/315.0 + - dampi6/1890.0)*expi - - termk2*(1.0 + dampk + 0.5*dampk2 + dampk3/6.0 + 5.0*dampk4/126.0 + - 2.0*dampk5/315.0 + dampk6/1890.0)*expk - - 2.0*termi2*termk*(1.0 + dampi + 4.0*dampi2/9.0 + dampi3/9.0 + - dampi4/63.0 + dampi5/945.0)*expi - - 2.0*termk2*termi*(1.0 + dampk + 4.0*dampk2/9.0 + dampk3/9.0 + + dmpik[10] = 1.0 - termi2*(1.0 + dampi + 0.5*dampi2 + dampi3/6.0 + + 5.0*dampi4/126.0 + 2.0*dampi5/315.0 + + dampi6/1890.0)*expi - + termk2*(1.0 + dampk + 0.5*dampk2 + dampk3/6.0 + 5.0*dampk4/126.0 + + 2.0*dampk5/315.0 + dampk6/1890.0)*expk - + 2.0*termi2*termk*(1.0 + dampi + 4.0*dampi2/9.0 + dampi3/9.0 + + dampi4/63.0 + dampi5/945.0)*expi - + 2.0*termk2*termi*(1.0 + dampk + 4.0*dampk2/9.0 + dampk3/9.0 + dampk4/63.0 + dampk5/945.0)*expk; } } diff --git a/src/AMOEBA/amoeba_polar.cpp b/src/AMOEBA/amoeba_polar.cpp index cf62599a23..55cafd32f6 100644 --- a/src/AMOEBA/amoeba_polar.cpp +++ b/src/AMOEBA/amoeba_polar.cpp @@ -61,7 +61,7 @@ void PairAmoeba::polar() double tep[3]; // set cutoffs, taper coeffs, and PME params - + if (use_ewald) choose(POLAR_LONG); else choose(POLAR); @@ -122,11 +122,11 @@ void PairAmoeba::polar() vyy = yix*fix[1] + yiy*fiy[1] + yiz*fiz[1]; vzz = zix*fix[2] + ziy*fiy[2] + ziz*fiz[2]; - vxy = 0.5 * (yix*fix[0] + yiy*fiy[0] + yiz*fiz[0] + + vxy = 0.5 * (yix*fix[0] + yiy*fiy[0] + yiz*fiz[0] + xix*fix[1] + xiy*fiy[1] + xiz*fiz[1]); - vxz = 0.5 * (zix*fix[0] + ziy*fiy[0] + ziz*fiz[0] + + vxz = 0.5 * (zix*fix[0] + ziy*fiy[0] + ziz*fiz[0] + xix*fix[2] + xiy*fiy[2] + xiz*fiz[2]); - vyz = 0.5 * (zix*fix[1] + ziy*fiy[1] + ziz*fiz[1] + + vyz = 0.5 * (zix*fix[1] + ziy*fiy[1] + ziz*fiz[1] + yix*fix[2] + yiy*fiy[2] + yiz*fiz[2]); virpolar[0] += vxx; @@ -139,7 +139,7 @@ void PairAmoeba::polar() // clean up // qfac was allocated in induce - + if (use_ewald) memory->destroy(qfac); } @@ -172,7 +172,7 @@ void PairAmoeba::polar_energy() itype = amtype[i]; fi = felec / polarity[itype]; e = 0.0; - for (j = 0; j < 3; j++) + for (j = 0; j < 3; j++) e += fi*uind[i][j]*udirp[i][j]; epolar += e; } @@ -301,7 +301,7 @@ void PairAmoeba::polar_real() // set the energy unit conversion factor // NOTE: why 1/2 ? - + felec = 0.5 * electric / am_dielectric; // compute the dipole polarization gradient components @@ -368,32 +368,32 @@ void PairAmoeba::polar_real() yr = x[j][1] - yi; zr = x[j][2] - zi; r2 = xr*xr + yr*yr + zr*zr; - if (r2 > off2) continue; + if (r2 > off2) continue; jtype = amtype[j]; jclass = amtype2class[jtype]; jgroup = amgroup[j]; if (amoeba) { - factor_wscale = special_polar_wscale[sbmask15(jextra)]; - if (igroup == jgroup) { - factor_pscale = special_polar_piscale[sbmask15(jextra)]; - factor_dscale = polar_dscale; - factor_uscale = polar_uscale; - } else { - factor_pscale = special_polar_pscale[sbmask15(jextra)]; - factor_dscale = factor_uscale = 1.0; - } - + factor_wscale = special_polar_wscale[sbmask15(jextra)]; + if (igroup == jgroup) { + factor_pscale = special_polar_piscale[sbmask15(jextra)]; + factor_dscale = polar_dscale; + factor_uscale = polar_uscale; + } else { + factor_pscale = special_polar_pscale[sbmask15(jextra)]; + factor_dscale = factor_uscale = 1.0; + } + } else if (hippo) { - factor_wscale = special_polar_wscale[sbmask15(jextra)]; - if (igroup == jgroup) { - factor_dscale = factor_pscale = special_polar_piscale[sbmask15(jextra)]; - factor_uscale = polar_uscale; - } else { - factor_dscale = factor_pscale = special_polar_pscale[sbmask15(jextra)]; - factor_uscale = 1.0; - } + factor_wscale = special_polar_wscale[sbmask15(jextra)]; + if (igroup == jgroup) { + factor_dscale = factor_pscale = special_polar_piscale[sbmask15(jextra)]; + factor_uscale = polar_uscale; + } else { + factor_dscale = factor_pscale = special_polar_pscale[sbmask15(jextra)]; + factor_uscale = 1.0; + } } r = sqrt(r2); @@ -569,9 +569,9 @@ void PairAmoeba::polar_real() ufld[j][0] += tkx3 + xr*tukr; ufld[j][1] += tky3 + yr*tukr; ufld[j][2] += tkz3 + zr*tukr; - + // get induced dipole field gradient used for quadrupole torques - + if (amoeba) { tix5 = 2.0 * (psr5*ukx+dsr5*ukxp); tiy5 = 2.0 * (psr5*uky+dsr5*ukyp); @@ -608,7 +608,7 @@ void PairAmoeba::polar_real() dufld[j][5] -= zr*tkz5 + zr*zr*tukr; // get the dEd/dR terms used for direct polarization force - + if (amoeba) { term1 = bn[2] - dsc3*rr5; term2 = bn[3] - dsc5*rr7; @@ -618,61 +618,61 @@ void PairAmoeba::polar_real() term6 = (bn[4]-dsc7*rr9)*xr*xr - bn[3] - rr7*xr*drc7[0]; term7 = rr5*drc5[0] - 2.0*bn[3]*xr + (dsc5+1.5*dsc7)*rr7*xr; tixx = ci*term3 + dix*term4 + dir*term5 + - 2.0*dsr5*qixx + (qiy*yr+qiz*zr)*dsc7*rr7 + 2.0*qix*term7 + qir*term6; + 2.0*dsr5*qixx + (qiy*yr+qiz*zr)*dsc7*rr7 + 2.0*qix*term7 + qir*term6; tkxx = ck*term3 - dkx*term4 - dkr*term5 + - 2.0*dsr5*qkxx + (qky*yr+qkz*zr)*dsc7*rr7 + 2.0*qkx*term7 + qkr*term6; + 2.0*dsr5*qkxx + (qky*yr+qkz*zr)*dsc7*rr7 + 2.0*qkx*term7 + qkr*term6; term3 = -dsr3 + term1*yr*yr - rr3*yr*drc3[1]; term4 = rr3*drc3[1] - term1*yr - dsr5*yr; term5 = term2*yr*yr - dsr5 - rr5*yr*drc5[1]; term6 = (bn[4]-dsc7*rr9)*yr*yr - bn[3] - rr7*yr*drc7[1]; term7 = rr5*drc5[1] - 2.0*bn[3]*yr + (dsc5+1.5*dsc7)*rr7*yr; tiyy = ci*term3 + diy*term4 + dir*term5 + - 2.0*dsr5*qiyy + (qix*xr+qiz*zr)*dsc7*rr7 + 2.0*qiy*term7 + qir*term6; + 2.0*dsr5*qiyy + (qix*xr+qiz*zr)*dsc7*rr7 + 2.0*qiy*term7 + qir*term6; tkyy = ck*term3 - dky*term4 - dkr*term5 + - 2.0*dsr5*qkyy + (qkx*xr+qkz*zr)*dsc7*rr7 + 2.0*qky*term7 + qkr*term6; + 2.0*dsr5*qkyy + (qkx*xr+qkz*zr)*dsc7*rr7 + 2.0*qky*term7 + qkr*term6; term3 = -dsr3 + term1*zr*zr - rr3*zr*drc3[2]; term4 = rr3*drc3[2] - term1*zr - dsr5*zr; term5 = term2*zr*zr - dsr5 - rr5*zr*drc5[2]; term6 = (bn[4]-dsc7*rr9)*zr*zr - bn[3] - rr7*zr*drc7[2]; term7 = rr5*drc5[2] - 2.0*bn[3]*zr + (dsc5+1.5*dsc7)*rr7*zr; tizz = ci*term3 + diz*term4 + dir*term5 + - 2.0*dsr5*qizz + (qix*xr+qiy*yr)*dsc7*rr7 + 2.0*qiz*term7 + qir*term6; + 2.0*dsr5*qizz + (qix*xr+qiy*yr)*dsc7*rr7 + 2.0*qiz*term7 + qir*term6; tkzz = ck*term3 - dkz*term4 - dkr*term5 + - 2.0*dsr5*qkzz + (qkx*xr+qky*yr)*dsc7*rr7 + 2.0*qkz*term7 + qkr*term6; + 2.0*dsr5*qkzz + (qkx*xr+qky*yr)*dsc7*rr7 + 2.0*qkz*term7 + qkr*term6; term3 = term1*xr*yr - rr3*yr*drc3[0]; term4 = rr3*drc3[0] - term1*xr; term5 = term2*xr*yr - rr5*yr*drc5[0]; term6 = (bn[4]-dsc7*rr9)*xr*yr - rr7*yr*drc7[0]; term7 = rr5*drc5[0] - term2*xr; tixy = ci*term3 - dsr5*dix*yr + diy*term4 + dir*term5 + - 2.0*dsr5*qixy - 2.0*dsr7*yr*qix + 2.0*qiy*term7 + qir*term6; + 2.0*dsr5*qixy - 2.0*dsr7*yr*qix + 2.0*qiy*term7 + qir*term6; tkxy = ck*term3 + dsr5*dkx*yr - dky*term4 - dkr*term5 + - 2.0*dsr5*qkxy - 2.0*dsr7*yr*qkx + 2.0*qky*term7 + qkr*term6; + 2.0*dsr5*qkxy - 2.0*dsr7*yr*qkx + 2.0*qky*term7 + qkr*term6; term3 = term1*xr*zr - rr3*zr*drc3[0]; term5 = term2*xr*zr - rr5*zr*drc5[0]; term6 = (bn[4]-dsc7*rr9)*xr*zr - rr7*zr*drc7[0]; tixz = ci*term3 - dsr5*dix*zr + diz*term4 + dir*term5 + - 2.0*dsr5*qixz - 2.0*dsr7*zr*qix + 2.0*qiz*term7 + qir*term6; + 2.0*dsr5*qixz - 2.0*dsr7*zr*qix + 2.0*qiz*term7 + qir*term6; tkxz = ck*term3 + dsr5*dkx*zr - dkz*term4 - dkr*term5 + - 2.0*dsr5*qkxz - 2.0*dsr7*zr*qkx + 2.0*qkz*term7 + qkr*term6; + 2.0*dsr5*qkxz - 2.0*dsr7*zr*qkx + 2.0*qkz*term7 + qkr*term6; term3 = term1*yr*zr - rr3*zr*drc3[1]; term4 = rr3*drc3[1] - term1*yr; term5 = term2*yr*zr - rr5*zr*drc5[1]; term6 = (bn[4]-dsc7*rr9)*yr*zr - rr7*zr*drc7[1]; term7 = rr5*drc5[1] - term2*yr; tiyz = ci*term3 - dsr5*diy*zr + diz*term4 + dir*term5 + - 2.0*dsr5*qiyz - 2.0*dsr7*zr*qiy + 2.0*qiz*term7 + qir*term6; + 2.0*dsr5*qiyz - 2.0*dsr7*zr*qiy + 2.0*qiz*term7 + qir*term6; tkyz = ck*term3 + dsr5*dky*zr - dkz*term4 - dkr*term5 + - 2.0*dsr5*qkyz - 2.0*dsr7*zr*qky + 2.0*qkz*term7 + qkr*term6; + 2.0*dsr5*qkyz - 2.0*dsr7*zr*qky + 2.0*qkz*term7 + qkr*term6; depx = tixx*ukxp + tixy*ukyp + tixz*ukzp - tkxx*uixp - tkxy*uiyp - tkxz*uizp; depy = tixy*ukxp + tiyy*ukyp + tiyz*ukzp - tkxy*uixp - tkyy*uiyp - tkyz*uizp; depz = tixz*ukxp + tiyz*ukyp + tizz*ukzp - tkxz*uixp - tkyz*uiyp - tkzz*uizp; frcx = depx; frcy = depy; frcz = depz; - + // get the dEp/dR terms used for direct polarization force - + term1 = bn[2] - psc3*rr5; term2 = bn[3] - psc5*rr7; term3 = -psr3 + term1*xr*xr - rr3*xr*prc3[0]; @@ -681,52 +681,52 @@ void PairAmoeba::polar_real() term6 = (bn[4]-psc7*rr9)*xr*xr - bn[3] - rr7*xr*prc7[0]; term7 = rr5*prc5[0] - 2.0*bn[3]*xr + (psc5+1.5*psc7)*rr7*xr; tixx = ci*term3 + dix*term4 + dir*term5 + - 2.0*psr5*qixx + (qiy*yr+qiz*zr)*psc7*rr7 + 2.0*qix*term7 + qir*term6; + 2.0*psr5*qixx + (qiy*yr+qiz*zr)*psc7*rr7 + 2.0*qix*term7 + qir*term6; tkxx = ck*term3 - dkx*term4 - dkr*term5 + - 2.0*psr5*qkxx + (qky*yr+qkz*zr)*psc7*rr7 + 2.0*qkx*term7 + qkr*term6; + 2.0*psr5*qkxx + (qky*yr+qkz*zr)*psc7*rr7 + 2.0*qkx*term7 + qkr*term6; term3 = -psr3 + term1*yr*yr - rr3*yr*prc3[1]; term4 = rr3*prc3[1] - term1*yr - psr5*yr; term5 = term2*yr*yr - psr5 - rr5*yr*prc5[1]; term6 = (bn[4]-psc7*rr9)*yr*yr - bn[3] - rr7*yr*prc7[1]; term7 = rr5*prc5[1] - 2.0*bn[3]*yr + (psc5+1.5*psc7)*rr7*yr; tiyy = ci*term3 + diy*term4 + dir*term5 + - 2.0*psr5*qiyy + (qix*xr+qiz*zr)*psc7*rr7 + 2.0*qiy*term7 + qir*term6; + 2.0*psr5*qiyy + (qix*xr+qiz*zr)*psc7*rr7 + 2.0*qiy*term7 + qir*term6; tkyy = ck*term3 - dky*term4 - dkr*term5 + - 2.0*psr5*qkyy + (qkx*xr+qkz*zr)*psc7*rr7 + 2.0*qky*term7 + qkr*term6; + 2.0*psr5*qkyy + (qkx*xr+qkz*zr)*psc7*rr7 + 2.0*qky*term7 + qkr*term6; term3 = -psr3 + term1*zr*zr - rr3*zr*prc3[2]; term4 = rr3*prc3[2] - term1*zr - psr5*zr; term5 = term2*zr*zr - psr5 - rr5*zr*prc5[2]; term6 = (bn[4]-psc7*rr9)*zr*zr - bn[3] - rr7*zr*prc7[2]; term7 = rr5*prc5[2] - 2.0*bn[3]*zr + (psc5+1.5*psc7)*rr7*zr; tizz = ci*term3 + diz*term4 + dir*term5 + - 2.0*psr5*qizz + (qix*xr+qiy*yr)*psc7*rr7 + 2.0*qiz*term7 + qir*term6; + 2.0*psr5*qizz + (qix*xr+qiy*yr)*psc7*rr7 + 2.0*qiz*term7 + qir*term6; tkzz = ck*term3 - dkz*term4 - dkr*term5 + - 2.0*psr5*qkzz + (qkx*xr+qky*yr)*psc7*rr7 + 2.0*qkz*term7 + qkr*term6; + 2.0*psr5*qkzz + (qkx*xr+qky*yr)*psc7*rr7 + 2.0*qkz*term7 + qkr*term6; term3 = term1*xr*yr - rr3*yr*prc3[0]; term4 = rr3*prc3[0] - term1*xr; term5 = term2*xr*yr - rr5*yr*prc5[0]; term6 = (bn[4]-psc7*rr9)*xr*yr - rr7*yr*prc7[0]; term7 = rr5*prc5[0] - term2*xr; tixy = ci*term3 - psr5*dix*yr + diy*term4 + dir*term5 + - 2.0*psr5*qixy - 2.0*psr7*yr*qix + 2.0*qiy*term7 + qir*term6; + 2.0*psr5*qixy - 2.0*psr7*yr*qix + 2.0*qiy*term7 + qir*term6; tkxy = ck*term3 + psr5*dkx*yr - dky*term4 - dkr*term5 + - 2.0*psr5*qkxy - 2.0*psr7*yr*qkx + 2.0*qky*term7 + qkr*term6; + 2.0*psr5*qkxy - 2.0*psr7*yr*qkx + 2.0*qky*term7 + qkr*term6; term3 = term1*xr*zr - rr3*zr*prc3[0]; term5 = term2*xr*zr - rr5*zr*prc5[0]; term6 = (bn[4]-psc7*rr9)*xr*zr - rr7*zr*prc7[0]; tixz = ci*term3 - psr5*dix*zr + diz*term4 + dir*term5 + - 2.0*psr5*qixz - 2.0*psr7*zr*qix + 2.0*qiz*term7 + qir*term6; + 2.0*psr5*qixz - 2.0*psr7*zr*qix + 2.0*qiz*term7 + qir*term6; tkxz = ck*term3 + psr5*dkx*zr - dkz*term4 - dkr*term5 + - 2.0*psr5*qkxz - 2.0*psr7*zr*qkx + 2.0*qkz*term7 + qkr*term6; + 2.0*psr5*qkxz - 2.0*psr7*zr*qkx + 2.0*qkz*term7 + qkr*term6; term3 = term1*yr*zr - rr3*zr*prc3[1]; term4 = rr3*prc3[1] - term1*yr; term5 = term2*yr*zr - rr5*zr*prc5[1]; term6 = (bn[4]-psc7*rr9)*yr*zr - rr7*zr*prc7[1]; term7 = rr5*prc5[1] - term2*yr; tiyz = ci*term3 - psr5*diy*zr + diz*term4 + dir*term5 + - 2.0*psr5*qiyz - 2.0*psr7*zr*qiy + 2.0*qiz*term7 + qir*term6; + 2.0*psr5*qiyz - 2.0*psr7*zr*qiy + 2.0*qiz*term7 + qir*term6; tkyz = ck*term3 + psr5*dky*zr - dkz*term4 - dkr*term5 + - 2.0*psr5*qkyz - 2.0*psr7*zr*qky + 2.0*qkz*term7 + qkr*term6; + 2.0*psr5*qkyz - 2.0*psr7*zr*qky + 2.0*qkz*term7 + qkr*term6; depx = tixx*ukx + tixy*uky + tixz*ukz - tkxx*uix - tkxy*uiy - tkxz*uiz; depy = tixy*ukx + tiyy*uky + tiyz*ukz - tkxy*uix - tkyy*uiy - tkyz*uiz; depz = tixz*ukx + tiyz*uky + tizz*ukz - tkxz*uix - tkyz*uiy - tkzz*uiz; @@ -735,7 +735,7 @@ void PairAmoeba::polar_real() frcz = frcz + depz; // get the field gradient for direct polarization force - + } else if (hippo) { term1i = rr3i - rr5i*xr*xr; term1core = rr3core - rr5core*xr*xr; @@ -751,9 +751,9 @@ void PairAmoeba::polar_real() term5k = 5.0*rr7k*xr; term6k = rr9k*xr*xr; tixx = vali*term1i + corei*term1core + dix*term2i - dir*term3i - - qixx*term4i + qix*term5i - qir*term6i + (qiy*yr+qiz*zr)*rr7i; + qixx*term4i + qix*term5i - qir*term6i + (qiy*yr+qiz*zr)*rr7i; tkxx = valk*term1k + corek*term1core - dkx*term2k + dkr*term3k - - qkxx*term4k + qkx*term5k - qkr*term6k + (qky*yr+qkz*zr)*rr7k; + qkxx*term4k + qkx*term5k - qkr*term6k + (qky*yr+qkz*zr)*rr7k; term1i = rr3i - rr5i*yr*yr; term1core = rr3core - rr5core*yr*yr; term2i = 2.0*rr5i*yr; @@ -768,9 +768,9 @@ void PairAmoeba::polar_real() term5k = 5.0*rr7k*yr; term6k = rr9k*yr*yr; tiyy = vali*term1i + corei*term1core + diy*term2i - dir*term3i - - qiyy*term4i + qiy*term5i - qir*term6i + (qix*xr+qiz*zr)*rr7i; + qiyy*term4i + qiy*term5i - qir*term6i + (qix*xr+qiz*zr)*rr7i; tkyy = valk*term1k + corek*term1core - dky*term2k + dkr*term3k - - qkyy*term4k + qky*term5k - qkr*term6k + (qkx*xr+qkz*zr)*rr7k; + qkyy*term4k + qky*term5k - qkr*term6k + (qkx*xr+qkz*zr)*rr7k; term1i = rr3i - rr5i*zr*zr; term1core = rr3core - rr5core*zr*zr; term2i = 2.0*rr5i*zr; @@ -785,9 +785,9 @@ void PairAmoeba::polar_real() term5k = 5.0*rr7k*zr; term6k = rr9k*zr*zr; tizz = vali*term1i + corei*term1core + diz*term2i - dir*term3i - - qizz*term4i + qiz*term5i - qir*term6i + (qix*xr+qiy*yr)*rr7i; + qizz*term4i + qiz*term5i - qir*term6i + (qix*xr+qiy*yr)*rr7i; tkzz = valk*term1k + corek*term1core - dkz*term2k + dkr*term3k - - qkzz*term4k + qkz*term5k - qkr*term6k + (qkx*xr+qky*yr)*rr7k; + qkzz*term4k + qkz*term5k - qkr*term6k + (qkx*xr+qky*yr)*rr7k; term2i = rr5i*xr ; term1i = yr * term2i; term1core = rr5core*xr*yr; @@ -806,9 +806,9 @@ void PairAmoeba::polar_real() term7k = 2.0*rr7k*yr; term8k = yr*rr9k*xr; tixy = -vali*term1i - corei*term1core + diy*term2i + dix*term3i - - dir*term4i - qixy*term5i + qiy*term6i + qix*term7i - qir*term8i; + dir*term4i - qixy*term5i + qiy*term6i + qix*term7i - qir*term8i; tkxy = -valk*term1k - corek*term1core - dky*term2k - dkx*term3k + - dkr*term4k - qkxy*term5k + qky*term6k + qkx*term7k - qkr*term8k; + dkr*term4k - qkxy*term5k + qky*term6k + qkx*term7k - qkr*term8k; term2i = rr5i*xr; term1i = zr * term2i; term1core = rr5core*xr*zr; @@ -827,9 +827,9 @@ void PairAmoeba::polar_real() term7k = 2.0*rr7k*zr; term8k = zr*rr9k*xr; tixz = -vali*term1i - corei*term1core + diz*term2i + dix*term3i - - dir*term4i - qixz*term5i + qiz*term6i + qix*term7i - qir*term8i; + dir*term4i - qixz*term5i + qiz*term6i + qix*term7i - qir*term8i; tkxz = -valk*term1k - corek*term1core - dkz*term2k - dkx*term3k + - dkr*term4k - qkxz*term5k + qkz*term6k + qkx*term7k - qkr*term8k; + dkr*term4k - qkxz*term5k + qkz*term6k + qkx*term7k - qkr*term8k; term2i = rr5i*yr; term1i = zr * term2i; term1core = rr5core*yr*zr; @@ -848,9 +848,9 @@ void PairAmoeba::polar_real() term7k = 2.0*rr7k*zr; term8k = zr*rr9k*yr; tiyz = -vali*term1i - corei*term1core + diz*term2i + diy*term3i - - dir*term4i - qiyz*term5i + qiz*term6i + qiy*term7i - qir*term8i; + dir*term4i - qiyz*term5i + qiz*term6i + qiy*term7i - qir*term8i; tkyz = -valk*term1k - corek*term1core - dkz*term2k - dky*term3k + - dkr*term4k - qkyz*term5k + qkz*term6k + qky*term7k - qkr*term8k; + dkr*term4k - qkyz*term5k + qkz*term6k + qky*term7k - qkr*term8k; depx = tixx*ukx + tixy*uky + tixz*ukz - tkxx*uix - tkxy*uiy - tkxz*uiz; depy = tixy*ukx + tiyy*uky + tiyz*ukz - tkxy*uix - tkyy*uiy - tkyz*uiz; depz = tixz*ukx + tiyz*uky + tizz*ukz - tkxz*uix - tkyz*uiy - tkzz*uiz; @@ -860,7 +860,7 @@ void PairAmoeba::polar_real() } // get the dtau/dr terms used for mutual polarization force - + if (poltyp == MUTUAL && amoeba) { term1 = bn[2] - usc3*rr5; term2 = bn[3] - usc5*rr7; @@ -900,9 +900,9 @@ void PairAmoeba::polar_real() frcx = frcx + depx; frcy = frcy + depy; frcz = frcz + depz; - + // get the dtau/dr terms used for mutual polarization force - + } else if (poltyp == MUTUAL && hippo) { term1 = 2.0 * rr5ik; term2 = term1*xr; @@ -938,7 +938,7 @@ void PairAmoeba::polar_real() frcz = frcz - depz; // get the dtau/dr terms used for OPT polarization force - + } else if (poltyp == OPT && amoeba) { for (k = 0; k < optorder; k++) { uirm = uopt[i][k][0]*xr + uopt[i][k][1]*yr + uopt[i][k][2]*zr; @@ -974,19 +974,19 @@ void PairAmoeba::polar_real() tiyz = uopt[i][k][1]*term4 + uopt[i][k][2]*term5 + uirm*term6; tkyz = uopt[j][m][1]*term4 + uopt[j][m][2]*term5 + ukrm*term6; depx = tixx*uoptp[j][m][0] + tkxx*uoptp[i][k][0] + tixy*uoptp[j][m][1] + - tkxy*uoptp[i][k][1] + tixz*uoptp[j][m][2] + tkxz*uoptp[i][k][2]; + tkxy*uoptp[i][k][1] + tixz*uoptp[j][m][2] + tkxz*uoptp[i][k][2]; depy = tixy*uoptp[j][m][0] + tkxy*uoptp[i][k][0] + tiyy*uoptp[j][m][1] + - tkyy*uoptp[i][k][1] + tiyz*uoptp[j][m][2] + tkyz*uoptp[i][k][2]; + tkyy*uoptp[i][k][1] + tiyz*uoptp[j][m][2] + tkyz*uoptp[i][k][2]; depz = tixz*uoptp[j][m][0] + tkxz*uoptp[i][k][0] + tiyz*uoptp[j][m][1] + - tkyz*uoptp[i][k][1] + tizz*uoptp[j][m][2] + tkzz*uoptp[i][k][2]; + tkyz*uoptp[i][k][1] + tizz*uoptp[j][m][2] + tkzz*uoptp[i][k][2]; frcx += copm[k+m+1]*depx; frcy += copm[k+m+1]*depy; frcz += copm[k+m+1]*depz; } } - + // get the dtau/dr terms used for OPT polarization force - + } else if (poltyp == OPT && hippo) { for (k = 0; k < optorder; k++) { uirm = uopt[i][k][0]*xr + uopt[i][k][1]*yr + uopt[i][k][2]*zr; @@ -1019,19 +1019,19 @@ void PairAmoeba::polar_real() tiyz = uopt[i][k][1]*term1 + uopt[i][k][2]*term2 - uirm*term3; tkyz = uopt[j][m][1]*term1 + uopt[j][m][2]*term2 - ukrm*term3; depx = tixx*uoptp[j][m][0] + tkxx*uoptp[i][k][0] + tixy*uoptp[j][m][1] + - tkxy*uoptp[i][k][1] + tixz*uoptp[j][m][2] + tkxz*uoptp[i][k][2]; + tkxy*uoptp[i][k][1] + tixz*uoptp[j][m][2] + tkxz*uoptp[i][k][2]; depy = tixy*uoptp[j][m][0] + tkxy*uoptp[i][k][0] + tiyy*uoptp[j][m][1] + - tkyy*uoptp[i][k][1] + tiyz*uoptp[j][m][2] + tkyz*uoptp[i][k][2]; + tkyy*uoptp[i][k][1] + tiyz*uoptp[j][m][2] + tkyz*uoptp[i][k][2]; depz = tixz*uoptp[j][m][0] + tkxz*uoptp[i][k][0] + tiyz*uoptp[j][m][1] + - tkyz*uoptp[i][k][1] + tizz*uoptp[j][m][2] + tkzz*uoptp[i][k][2]; + tkyz*uoptp[i][k][1] + tizz*uoptp[j][m][2] + tkzz*uoptp[i][k][2]; frcx -= copm[k+m+1]*depx; frcy -= copm[k+m+1]*depy; frcz -= copm[k+m+1]*depz; } } - + // get the dtau/dr terms used for TCG polarization force - + } else if (poltyp == TCG) { /* for (m = 0; m < tcgnab; m++) { @@ -1137,9 +1137,9 @@ void PairAmoeba::polar_real() } */ } - + // increment force-based gradient on the interaction sites - + f[i][0] += frcx; f[i][1] += frcy; f[i][2] += frcz; @@ -1148,7 +1148,7 @@ void PairAmoeba::polar_real() f[j][2] -= frcz; // increment the virial due to pairwise Cartesian forces - + vxx = xr * frcx; vxy = 0.5 * (yr*frcx+xr*frcy); vxz = 0.5 * (zr*frcx+xr*frcz); @@ -1166,7 +1166,7 @@ void PairAmoeba::polar_real() // energy = e // virial = 6-vec vir // NOTE: add tally function - + if (evflag) { } } @@ -1178,7 +1178,7 @@ void PairAmoeba::polar_real() comm->reverse_comm(this); // torque is induced field and gradient cross permanent moments - + for (i = 0; i < nlocal; i++) { dix = rpole[i][1]; diy = rpole[i][2]; @@ -1189,18 +1189,18 @@ void PairAmoeba::polar_real() qiyy = rpole[i][8]; qiyz = rpole[i][9]; qizz = rpole[i][12]; - tep[0] = diz*ufld[i][1] - diy*ufld[i][2] + + tep[0] = diz*ufld[i][1] - diy*ufld[i][2] + qixz*dufld[i][1] - qixy*dufld[i][3] + 2.0*qiyz*(dufld[i][2]-dufld[i][5]) + (qizz-qiyy)*dufld[i][4]; - tep[1] = dix*ufld[i][2] - diz*ufld[i][0] - - qiyz*dufld[i][1] + qixy*dufld[i][4] + + tep[1] = dix*ufld[i][2] - diz*ufld[i][0] - + qiyz*dufld[i][1] + qixy*dufld[i][4] + 2.0*qixz*(dufld[i][5]-dufld[i][0]) + (qixx-qizz)*dufld[i][3]; - tep[2] = diy*ufld[i][0] - dix*ufld[i][1] + - qiyz*dufld[i][3] - qixz*dufld[i][4] + + tep[2] = diy*ufld[i][0] - dix*ufld[i][1] + + qiyz*dufld[i][3] - qixz*dufld[i][4] + 2.0*qixy*(dufld[i][0]-dufld[i][2]) + (qiyy-qixx)*dufld[i][1]; torque2force(i,tep,fix,fiy,fiz,f); - + iz = zaxis2local[i]; ix = xaxis2local[i]; iy = yaxis2local[i]; @@ -1218,11 +1218,11 @@ void PairAmoeba::polar_real() vxx = xix*fix[0] + xiy*fiy[0] + xiz*fiz[0]; vyy = yix*fix[1] + yiy*fiy[1] + yiz*fiz[1]; vzz = zix*fix[2] + ziy*fiy[2] + ziz*fiz[2]; - vxy = 0.5 * (yix*fix[0] + yiy*fiy[0] + yiz*fiz[0] + + vxy = 0.5 * (yix*fix[0] + yiy*fiy[0] + yiz*fiz[0] + xix*fix[1] + xiy*fiy[1] + xiz*fiz[1]); - vxz = 0.5 * (zix*fix[0] + ziy*fiy[0] + ziz*fiz[0] + + vxz = 0.5 * (zix*fix[0] + ziy*fiy[0] + ziz*fiz[0] + xix*fix[2] + xiy*fiy[2] + xiz*fiz[2]); - vyz = 0.5 * (zix*fix[1] + ziy*fiy[1] + ziz*fiz[1] + + vyz = 0.5 * (zix*fix[1] + ziy*fiy[1] + ziz*fiz[1] + yix*fix[2] + yiy*fiy[2] + yiz*fiz[2]); virpolar[0] += vxx; @@ -1267,7 +1267,7 @@ void PairAmoeba::polar_kspace() double **fuind,**fuinp,**fphid,**fphip; double **fphidp,**cphidp; - + // indices into the electrostatic field array // decremented by 1 versus Fortran @@ -1288,7 +1288,7 @@ void PairAmoeba::polar_kspace() double volbox = domain->prd[0] * domain->prd[1] * domain->prd[2]; pterm = pow((MY_PI/aewald),2.0); volterm = MY_PI * volbox; - + // initialize variables required for the scalar summation felec = electric / am_dielectric; @@ -1296,7 +1296,7 @@ void PairAmoeba::polar_kspace() // dynamic allocation of local arrays // NOTE: just do this one time? // NOTE: overlap with induce - + memory->create(fuind,nlocal,3,"polar:fuind"); memory->create(fuinp,nlocal,3,"polar:fuinp"); memory->create(fphid,nlocal,10,"polar:fphid"); @@ -1325,10 +1325,10 @@ void PairAmoeba::polar_kspace() nzhi = p_kspace->nzhi_fft; // use previous results or compute new qfac and convolution - + if (aewald == aeewald) { vxx = -vmsave[0]; - vyy = -vmsave[1]; + vyy = -vmsave[1]; vzz = -vmsave[2]; vxy = -vmsave[3]; vxz = -vmsave[4]; @@ -1350,20 +1350,20 @@ void PairAmoeba::polar_kspace() double ***gridpre = (double ***) p_kspace->zero(); // map atoms to grid - + grid_mpole(fmp,gridpre); // pre-convolution operations including forward FFT // gridfft = my portion of complex 3d grid in FFT decomp as 1d vector - + double *gridfft = p_kspace->pre_convolution(); - + // --------------------- - // convolution operation + // convolution operation // --------------------- - + // zero virial accumulation variables - + vxx = vyy = vzz = vxy = vxz = vyz = 0.0; // perform convolution on K-space points I own @@ -1371,50 +1371,50 @@ void PairAmoeba::polar_kspace() m = n = 0; for (k = nzlo; k <= nzhi; k++) { for (j = nylo; j <= nyhi; j++) { - for (i = nxlo; i <= nxhi; i++) { - r1 = (i >= nhalf1) ? i-nfft1 : i; - r2 = (j >= nhalf2) ? j-nfft2 : j; - r3 = (k >= nhalf3) ? k-nfft3 : k; - h1 = recip[0][0]*r1 + recip[0][1]*r2 + recip[0][2]*r3; // matvec - h2 = recip[1][0]*r1 + recip[1][1]*r2 + recip[1][2]*r3; - h3 = recip[2][0]*r1 + recip[2][1]*r2 + recip[2][2]*r3; - hsq = h1*h1 + h2*h2 + h3*h3; - term = -pterm * hsq; - expterm = 0.0; - if (term > -50.0 && hsq != 0.0) { + for (i = nxlo; i <= nxhi; i++) { + r1 = (i >= nhalf1) ? i-nfft1 : i; + r2 = (j >= nhalf2) ? j-nfft2 : j; + r3 = (k >= nhalf3) ? k-nfft3 : k; + h1 = recip[0][0]*r1 + recip[0][1]*r2 + recip[0][2]*r3; // matvec + h2 = recip[1][0]*r1 + recip[1][1]*r2 + recip[1][2]*r3; + h3 = recip[2][0]*r1 + recip[2][1]*r2 + recip[2][2]*r3; + hsq = h1*h1 + h2*h2 + h3*h3; + term = -pterm * hsq; + expterm = 0.0; + if (term > -50.0 && hsq != 0.0) { denom = volterm*hsq*bsmod1[i]*bsmod2[j]*bsmod3[k]; - if (hsq) expterm = exp(term) / denom; - struc2 = gridfft[n]*gridfft[n] + gridfft[n+1]*gridfft[n+1]; - eterm = 0.5 * felec * expterm * struc2; - vterm = (2.0/hsq) * (1.0-term) * eterm; + if (hsq) expterm = exp(term) / denom; + struc2 = gridfft[n]*gridfft[n] + gridfft[n+1]*gridfft[n+1]; + eterm = 0.5 * felec * expterm * struc2; + vterm = (2.0/hsq) * (1.0-term) * eterm; vxx -= h1*h1*vterm - eterm; - vyy -= h2*h2*vterm - eterm; - vzz -= h3*h3*vterm - eterm; - vxy -= h1*h2*vterm; - vxz -= h1*h3*vterm; - vyz -= h2*h3*vterm; - } - + vyy -= h2*h2*vterm - eterm; + vzz -= h3*h3*vterm - eterm; + vxy -= h1*h2*vterm; + vxz -= h1*h3*vterm; + vyz -= h2*h3*vterm; + } + expterm = qfac[m++]; - gridfft[n] *= expterm; - gridfft[n+1] *= expterm; - n += 2; - } + gridfft[n] *= expterm; + gridfft[n+1] *= expterm; + n += 2; + } } } // post-convolution operations including backward FFT // gridppost = my portion of 3d grid in brick decomp w/ ghost values - + double ***gridpost = (double ***) p_kspace->post_convolution(); - + // get potential - + fphi_mpole(gridpost,fphi); for (i = 0; i < nlocal; i++) { for (k = 0; k < 20; k++) - fphi[i][k] *= felec; + fphi[i][k] *= felec; } // convert field from fractional to Cartesian @@ -1423,7 +1423,7 @@ void PairAmoeba::polar_kspace() } // convert Cartesian induced dipoles to fractional coordinates - + for (i = 0; i < 3; i++) { a[0][i] = nfft1 * recip[0][i]; a[1][i] = nfft2 * recip[1][i]; @@ -1449,15 +1449,15 @@ void PairAmoeba::polar_kspace() // pre-convolution operations including forward FFT // gridfft = my portion of complex 3d grid in FFT decomposition - + double *gridfft = pc_kspace->pre_convolution(); // --------------------- - // convolution operation + // convolution operation // --------------------- // use qfac values from above or from induce() - + m = n = 0; for (k = nzlo; k <= nzhi; k++) { for (j = nylo; j <= nyhi; j++) { @@ -1465,7 +1465,7 @@ void PairAmoeba::polar_kspace() term = qfac[m++]; gridfft[n] *= term; gridfft[n+1] *= term; - n += 2; + n += 2; } } } @@ -1548,27 +1548,27 @@ void PairAmoeba::polar_kspace() } } - vxx -= cmp[i][1]*cphidp[i][1] + + vxx -= cmp[i][1]*cphidp[i][1] + 0.5*((uind[i][0]+uinp[i][0])*cphi[i][1]); - vyy -= cmp[i][2]*cphidp[i][2] + + vyy -= cmp[i][2]*cphidp[i][2] + 0.5*((uind[i][1]+uinp[i][1])*cphi[i][2]); - vzz -= cmp[i][3]*cphidp[i][3] + + vzz -= cmp[i][3]*cphidp[i][3] + 0.5*((uind[i][2]+uinp[i][2])*cphi[i][3]); - vxy -= 0.5*(cphidp[i][1]*cmp[i][2]+cphidp[i][2]*cmp[i][1]) + + vxy -= 0.5*(cphidp[i][1]*cmp[i][2]+cphidp[i][2]*cmp[i][1]) + 0.25*((uind[i][1]+uinp[i][1])*cphi[i][1] + (uind[i][0]+uinp[i][0])*cphi[i][2]); vyz -= 0.5*(cphidp[i][2]*cmp[i][3]+cphidp[i][3]*cmp[i][2]) + 0.25*((uind[i][2]+uinp[i][2])*cphi[i][2] + (uind[i][1]+uinp[i][1])*cphi[i][3]); vxz -= 0.5*(cphidp[i][1]*cmp[i][3]+cphidp[i][3]*cmp[i][1]) + - 0.25*((uind[i][2]+uinp[i][2])*cphi[i][1] + + 0.25*((uind[i][2]+uinp[i][2])*cphi[i][1] + (uind[i][0]+uinp[i][0])*cphi[i][3]); - vxx -= 2.0*cmp[i][4]*cphidp[i][4] + cmp[i][7]*cphidp[i][7] + + vxx -= 2.0*cmp[i][4]*cphidp[i][4] + cmp[i][7]*cphidp[i][7] + cmp[i][8]*cphidp[i][8]; vyy -= 2.0*cmp[i][5]*cphidp[i][5] + cmp[i][7]*cphidp[i][7] + cmp[i][9]*cphidp[i][9]; - vzz -= 2.0*cmp[i][6]*cphidp[i][6] + cmp[i][8]*cphidp[i][8] + + vzz -= 2.0*cmp[i][6]*cphidp[i][6] + cmp[i][8]*cphidp[i][8] + cmp[i][9]*cphidp[i][9]; vxy -= (cmp[i][4]+cmp[i][5])*cphidp[i][7] + 0.5*(cmp[i][7]*(cphidp[i][5]+cphidp[i][4]) + @@ -1576,7 +1576,7 @@ void PairAmoeba::polar_kspace() vyz -= (cmp[i][5]+cmp[i][6])*cphidp[i][9] + 0.5*(cmp[i][9]*(cphidp[i][5]+cphidp[i][6]) + cmp[i][7]*cphidp[i][8]+cmp[i][8]*cphidp[i][7]); - vxz -= (cmp[i][4]+cmp[i][6])*cphidp[i][8] + + vxz -= (cmp[i][4]+cmp[i][6])*cphidp[i][8] + 0.5*(cmp[i][8]*(cphidp[i][4]+cphidp[i][6]) + cmp[i][7]*cphidp[i][9]+cmp[i][9]*cphidp[i][7]); @@ -1585,11 +1585,11 @@ void PairAmoeba::polar_kspace() vyy -= 0.5 * (cphid[2]*uinp[i][1]+cphip[2]*uind[i][1]); vzz -= 0.5 * (cphid[3]*uinp[i][2]+cphip[3]*uind[i][2]); vxy -= 0.25 * (cphid[1]*uinp[i][1]+cphip[1]*uind[i][1] + - cphid[2]*uinp[i][0]+cphip[2]*uind[i][0]); + cphid[2]*uinp[i][0]+cphip[2]*uind[i][0]); vyz -= 0.25 * (cphid[2]*uinp[i][2]+cphip[2]*uind[i][2] + - cphid[3]*uinp[i][1]+cphip[3]*uind[i][1]); + cphid[3]*uinp[i][1]+cphip[3]*uind[i][1]); vxz -= 0.25 * (cphid[1]*uinp[i][2]+cphip[1]*uind[i][2] + - cphid[3]*uinp[i][0]+cphip[3]*uind[i][0]); + cphid[3]*uinp[i][0]+cphip[3]*uind[i][0]); } } @@ -1597,16 +1597,16 @@ void PairAmoeba::polar_kspace() // resolve site torques then increment forces and virial for (i = 0; i < nlocal; i++) { - tep[0] = cmp[i][3]*cphidp[i][2] - cmp[i][2]*cphidp[i][3] + - 2.0*(cmp[i][6]-cmp[i][5])*cphidp[i][9] + cmp[i][8]*cphidp[i][7] + + tep[0] = cmp[i][3]*cphidp[i][2] - cmp[i][2]*cphidp[i][3] + + 2.0*(cmp[i][6]-cmp[i][5])*cphidp[i][9] + cmp[i][8]*cphidp[i][7] + cmp[i][9]*cphidp[i][5]- cmp[i][7]*cphidp[i][8] - cmp[i][9]*cphidp[i][6]; - tep[1] = cmp[i][1]*cphidp[i][3] - cmp[i][3]*cphidp[i][1] + - 2.0*(cmp[i][4]-cmp[i][6])*cphidp[i][8] + cmp[i][7]*cphidp[i][9] + + tep[1] = cmp[i][1]*cphidp[i][3] - cmp[i][3]*cphidp[i][1] + + 2.0*(cmp[i][4]-cmp[i][6])*cphidp[i][8] + cmp[i][7]*cphidp[i][9] + cmp[i][8]*cphidp[i][6] - cmp[i][8]*cphidp[i][4] - cmp[i][9]*cphidp[i][7]; - tep[2] = cmp[i][2]*cphidp[i][1] - cmp[i][1]*cphidp[i][2] + - 2.0*(cmp[i][5]-cmp[i][4])*cphidp[i][7] + cmp[i][7]*cphidp[i][4] + + tep[2] = cmp[i][2]*cphidp[i][1] - cmp[i][1]*cphidp[i][2] + + 2.0*(cmp[i][5]-cmp[i][4])*cphidp[i][7] + cmp[i][7]*cphidp[i][4] + cmp[i][9]*cphidp[i][8] - cmp[i][7]*cphidp[i][5] - cmp[i][8]*cphidp[i][9]; - + torque2force(i,tep,fix,fiy,fiz,f); iz = zaxis2local[i]; @@ -1626,12 +1626,12 @@ void PairAmoeba::polar_kspace() vxx += xix*fix[0] + xiy*fiy[0] + xiz*fiz[0]; vyy += yix*fix[1] + yiy*fiy[1] + yiz*fiz[1]; vzz += zix*fix[2] + ziy*fiy[2] + ziz*fiz[2]; - vxy += 0.5*(yix*fix[0] + yiy*fiy[0] + yiz*fiz[0] + - xix*fix[1] + xiy*fiy[1] + xiz*fiz[1]); - vyz += 0.5*(zix*fix[1] + ziy*fiy[1] + ziz*fiz[1] + - yix*fix[2] + yiy*fiy[2] + yiz*fiz[2]); - vxz += 0.5*(zix*fix[0] + ziy*fiy[0] + ziz*fiz[0] + - xix*fix[2] + xiy*fiy[2] + xiz*fiz[2]); + vxy += 0.5*(yix*fix[0] + yiy*fiy[0] + yiz*fiz[0] + + xix*fix[1] + xiy*fiy[1] + xiz*fiz[1]); + vyz += 0.5*(zix*fix[1] + ziy*fiy[1] + ziz*fiz[1] + + yix*fix[2] + yiy*fiy[2] + yiz*fiz[2]); + vxz += 0.5*(zix*fix[0] + ziy*fiy[0] + ziz*fiz[0] + + xix*fix[2] + xiy*fiy[2] + xiz*fiz[2]); } // account for dipole response terms in the OPT method @@ -1643,12 +1643,12 @@ void PairAmoeba::polar_kspace() fphid[i][j] = felec * fopt[i][k][j]; fphip[i][j] = felec * foptp[i][k][j]; } - + for (m = 0; m < optorder-k; m++) { for (j = 0; j < 3; j++) { - fuind[i][j] = a[0][j]*uopt[i][m][0] + a[1][j]*uopt[i][m][1] + + fuind[i][j] = a[0][j]*uopt[i][m][0] + a[1][j]*uopt[i][m][1] + a[2][j]*uopt[i][m][2]; - fuinp[i][j] = a[0][j]*uoptp[i][m][0] + a[1][j]*uoptp[i][m][1] + + fuinp[i][j] = a[0][j]*uoptp[i][m][0] + a[1][j]*uoptp[i][m][1] + a[2][j]*uoptp[i][m][2]; } @@ -1692,7 +1692,7 @@ void PairAmoeba::polar_kspace() vzz -= 0.5*copm[k+m+1] * (cphid[3]*uoptp[i][m][2]+ cphip[3]*uopt[i][m][2]); vxy -= 0.25*copm[k+m+1] * - (cphid[1]*uoptp[i][m][1]+ cphip[1]*uopt[i][m][1]+ + (cphid[1]*uoptp[i][m][1]+ cphip[1]*uopt[i][m][1]+ cphid[2]*uoptp[i][m][0]+ cphip[2]*uopt[i][m][0]); vyz -= 0.25*copm[k+m+1] * (cphid[1]*uoptp[i][m][2]+ cphip[1]*uopt[i][m][2]+ @@ -1707,15 +1707,15 @@ void PairAmoeba::polar_kspace() // account for dipole response terms in the TCG method - /* + /* if (poltyp == TCG) { for (m = 0; m < tcgnab; m++) { for (i = 0; i < nlocal; i++) { for (j = 0; j < 3; j++) { - fuind[i][j] = a[0][j]*uad[i][m][0] + a[1][j]*uad[i][m][1] + + fuind[i][j] = a[0][j]*uad[i][m][0] + a[1][j]*uad[i][m][1] + a[2][j]*uad[i][m][2]; - fuinp[i][j] = a[0][j]*ubp[i][m][0] + a[1][j]*ubp[i][m][1] + + fuinp[i][j] = a[0][j]*ubp[i][m][0] + a[1][j]*ubp[i][m][1] + a[2][j]*ubp[i][m][2]; } } @@ -1789,9 +1789,9 @@ void PairAmoeba::polar_kspace() for (i = 0; i < nlocal; i++) { for (j = 0; j < 3; j++) { - fuind[i][j] = a[0][j]*ubd[i][m][0] + a[1][j]*ubd[i][m][1] + + fuind[i][j] = a[0][j]*ubd[i][m][0] + a[1][j]*ubd[i][m][1] + a[2][j]*ubd[i][m][2]; - fuinp[i][j] = a[0][j]*uap[i][m][0] + a[1][j]*uap[i][m][1] + + fuinp[i][j] = a[0][j]*uap[i][m][0] + a[1][j]*uap[i][m][1] + a[2][j]*uap[i][m][2]; } } @@ -1866,7 +1866,7 @@ void PairAmoeba::polar_kspace() */ // assign permanent and induced multipoles to the PME grid - + for (i = 0; i < nlocal; i++) { for (j = 1; j < 4; j++) cmp[i][j] += uinp[i][j-1]; @@ -1878,7 +1878,7 @@ void PairAmoeba::polar_kspace() // gridpre = my portion of 3d grid in brick decomp w/ ghost values // zeroed by zero() - + double ***gridpre = (double ***) p_kspace->zero(); // DEBUG @@ -1887,11 +1887,11 @@ void PairAmoeba::polar_kspace() for (k = p_kspace->nzlo_out; k <= p_kspace->nzhi_out; k++) { for (j = p_kspace->nylo_out; j <= p_kspace->nyhi_out; j++) { for (i = p_kspace->nxlo_out; i <= p_kspace->nxhi_out; i++) { - psum += gridpre[k][j][i]; + psum += gridpre[k][j][i]; } } } - + // map atoms to grid grid_mpole(fmp,gridpre); @@ -1903,7 +1903,7 @@ void PairAmoeba::polar_kspace() // gridfft1 = copy of first FFT // NOTE: need to allocate this, when is it freed? - + FFT_SCALAR *gridfft1; int nfft_owned = p_kspace->nfft_owned; memory->create(gridfft1,2*nfft_owned,"amoeba:gridfft1"); @@ -1922,7 +1922,7 @@ void PairAmoeba::polar_kspace() // gridpre = my portion of 3d grid in brick decomp w/ ghost values // zeroed by zero() - + gridpre = (double ***) p_kspace->zero(); // map atoms to grid @@ -1931,40 +1931,40 @@ void PairAmoeba::polar_kspace() // pre-convolution operations including forward FFT // gridfft1/2 = my portions of complex 3d grid in FFT decomp as 1d vectors - + double *gridfft2 = p_kspace->pre_convolution(); // --------------------- - // convolution operation + // convolution operation // --------------------- m = n = 0; for (k = nzlo; k <= nzhi; k++) { for (j = nylo; j <= nyhi; j++) { for (i = nxlo; i <= nxhi; i++) { - r1 = (i >= nhalf1) ? i-nfft1 : i; - r2 = (j >= nhalf2) ? j-nfft2 : j; - r3 = (k >= nhalf3) ? k-nfft3 : k; - h1 = recip[0][0]*r1 + recip[0][1]*r2 + recip[0][2]*r3; // matvec - h2 = recip[1][0]*r1 + recip[1][1]*r2 + recip[1][2]*r3; - h3 = recip[2][0]*r1 + recip[2][1]*r2 + recip[2][2]*r3; - hsq = h1*h1 + h2*h2 + h3*h3; - term = -pterm * hsq; - expterm = 0.0; - if (term > -50.0 && hsq != 0.0) { - denom = volterm*hsq*bsmod1[i]*bsmod2[j]*bsmod3[k]; - expterm = exp(term) / denom; - struc2 = gridfft1[n]*gridfft2[n] + gridfft1[n+1]*gridfft2[n+1]; - eterm = 0.5 * felec * expterm * struc2; - vterm = (2.0/hsq) * (1.0-term) * eterm; - vxx += h1*h1*vterm - eterm; - vyy += h2*h2*vterm - eterm; - vzz += h3*h3*vterm - eterm; - vxy += h1*h2*vterm; - vyz += h2*h3*vterm; - vxz += h1*h3*vterm; - } - n += 2; + r1 = (i >= nhalf1) ? i-nfft1 : i; + r2 = (j >= nhalf2) ? j-nfft2 : j; + r3 = (k >= nhalf3) ? k-nfft3 : k; + h1 = recip[0][0]*r1 + recip[0][1]*r2 + recip[0][2]*r3; // matvec + h2 = recip[1][0]*r1 + recip[1][1]*r2 + recip[1][2]*r3; + h3 = recip[2][0]*r1 + recip[2][1]*r2 + recip[2][2]*r3; + hsq = h1*h1 + h2*h2 + h3*h3; + term = -pterm * hsq; + expterm = 0.0; + if (term > -50.0 && hsq != 0.0) { + denom = volterm*hsq*bsmod1[i]*bsmod2[j]*bsmod3[k]; + expterm = exp(term) / denom; + struc2 = gridfft1[n]*gridfft2[n] + gridfft1[n+1]*gridfft2[n+1]; + eterm = 0.5 * felec * expterm * struc2; + vterm = (2.0/hsq) * (1.0-term) * eterm; + vxx += h1*h1*vterm - eterm; + vyy += h2*h2*vterm - eterm; + vzz += h3*h3*vterm - eterm; + vxy += h1*h2*vterm; + vyz += h2*h3*vterm; + vxz += h1*h3*vterm; + } + n += 2; } } } @@ -1972,23 +1972,23 @@ void PairAmoeba::polar_kspace() // assign only the induced dipoles to the PME grid // and perform the 3-D FFT forward transformation // NOTE: why is there no inverse FFT in this section? - + if (poltyp == DIRECT || poltyp == TCG) { for (i = 0; i < nlocal; i++) { - for (j = 0; j < 10; j++) + for (j = 0; j < 10; j++) cmp[i][j] = 0.0; - for (j = 1; j < 4; j++) + for (j = 1; j < 4; j++) cmp[i][j] = uinp[i][j-1]; } // convert Cartesian multipoles to fractional multipoles - + cmp_to_fmp(cmp,fmp); // gridpre = my portion of 3d grid in brick decomp w/ ghost values // zeroed by zero() - + double ***gridpre = (double ***) p_kspace->zero(); // map atoms to grid @@ -1997,19 +1997,19 @@ void PairAmoeba::polar_kspace() // pre-convolution operations including forward FFT // gridfft = my portion of complex 3d grid in FFT decomp as 1d vector - + double *gridfft = p_kspace->pre_convolution(); // gridfft1 = copy of first FFT // NOTE: do this same as above - + int nfft_owned = p_kspace->nfft_owned; memcpy(gridfft1,gridfft,2*nfft_owned*sizeof(double)); // assign ??? to the PME grid for (i = 0; i < nlocal; i++) { - for (j = 1; j < 4; j++) + for (j = 1; j < 4; j++) cmp[i][j] = uind[i][j-1]; } @@ -2018,7 +2018,7 @@ void PairAmoeba::polar_kspace() cmp_to_fmp(cmp,fmp); // gridpre = my portion of 3d grid in brick decomp w/ ghost values - + gridpre = (double ***) p_kspace->zero(); // map atoms to grid @@ -2031,37 +2031,37 @@ void PairAmoeba::polar_kspace() double *gridfft2 = p_kspace->pre_convolution(); // --------------------- - // convolution operation + // convolution operation // --------------------- m = n = 0; for (k = nzlo; k <= nzhi; k++) { for (j = nylo; j <= nyhi; j++) { - for (i = nxlo; i <= nxhi; i++) { - r1 = (i >= nhalf1) ? i-nfft1 : i; - r2 = (j >= nhalf2) ? j-nfft2 : j; - r3 = (k >= nhalf3) ? k-nfft3 : k; - h1 = recip[0][0]*r1 + recip[0][1]*r2 + recip[0][2]*r3; // matvec - h2 = recip[1][0]*r1 + recip[1][1]*r2 + recip[1][2]*r3; - h3 = recip[2][0]*r1 + recip[2][1]*r2 + recip[2][2]*r3; - hsq = h1*h1 + h2*h2 + h3*h3; - term = -pterm * hsq; - expterm = 0.0; - if (term > -50.0 && hsq != 0.0) { - denom = volterm*hsq*bsmod1[i]*bsmod2[j]*bsmod3[k]; - expterm = exp(term) / denom; - struc2 = gridfft1[n]*gridfft2[n] + gridfft1[n+1]*gridfft2[n+1]; - eterm = 0.5 * felec * expterm * struc2; - vterm = (2.0/hsq) * (1.0-term) * eterm; - vxx += h1*h1*vterm - eterm; - vyy += h2*h2*vterm - eterm; - vzz += h3*h3*vterm - eterm; - vxy += h1*h2*vterm; - vyz += h2*h3*vterm; - vxz += h1*h3*vterm; - } - n += 2; - } + for (i = nxlo; i <= nxhi; i++) { + r1 = (i >= nhalf1) ? i-nfft1 : i; + r2 = (j >= nhalf2) ? j-nfft2 : j; + r3 = (k >= nhalf3) ? k-nfft3 : k; + h1 = recip[0][0]*r1 + recip[0][1]*r2 + recip[0][2]*r3; // matvec + h2 = recip[1][0]*r1 + recip[1][1]*r2 + recip[1][2]*r3; + h3 = recip[2][0]*r1 + recip[2][1]*r2 + recip[2][2]*r3; + hsq = h1*h1 + h2*h2 + h3*h3; + term = -pterm * hsq; + expterm = 0.0; + if (term > -50.0 && hsq != 0.0) { + denom = volterm*hsq*bsmod1[i]*bsmod2[j]*bsmod3[k]; + expterm = exp(term) / denom; + struc2 = gridfft1[n]*gridfft2[n] + gridfft1[n+1]*gridfft2[n+1]; + eterm = 0.5 * felec * expterm * struc2; + vterm = (2.0/hsq) * (1.0-term) * eterm; + vxx += h1*h1*vterm - eterm; + vyy += h2*h2*vterm - eterm; + vzz += h3*h3*vterm - eterm; + vxy += h1*h2*vterm; + vyz += h2*h3*vterm; + vxz += h1*h3*vterm; + } + n += 2; + } } } } @@ -2109,7 +2109,7 @@ void PairAmoeba::polar_kspace() for (m = 1; m < ntot; m++) { k1 = m % nfft1; k2 = (m % nff) / nfft1; - k3 = m/nff; + k3 = m/nff; r1 = (k1 >= nf1) ? k1-nfft1 : k1; r2 = (k2 >= nf2) ? k2-nfft2 : k2; r3 = (k3 >= nf3) ? k3-nfft3 : k3; @@ -2122,7 +2122,7 @@ void PairAmoeba::polar_kspace() if (term > -50.0 && hsq != 0.0) { denom = volterm*hsq*bsmod1[k1]*bsmod2[k2]*bsmod3[k3]; expterm = exp(term) / denom; - struc2 = qgrid[k3][k2][k1][0]*qgrip[k3][k2][k1][0] + + struc2 = qgrid[k3][k2][k1][0]*qgrip[k3][k2][k1][0] + qgrid[k3][k2][k1][1]*qgrip[k3][k2][k1][1]; eterm = 0.5 * felec * expterm * struc2; vterm = (2.0/hsq) * (1.0-term) * eterm; @@ -2172,11 +2172,11 @@ void PairAmoeba::polar_kspace() for (m = 1; m < ntot; m++) { k1 = m % nfft1; - k2 = (m % nff) / nfft1; - k3 = m/nff; - r1 = (k1 >= nf1) ? k1-nfft1 : k1; - r2 = (k2 >= nf2) ? k2-nfft2 : k2; - r3 = (k3 >= nf3) ? k3-nfft3 : k3; + k2 = (m % nff) / nfft1; + k3 = m/nff; + r1 = (k1 >= nf1) ? k1-nfft1 : k1; + r2 = (k2 >= nf2) ? k2-nfft2 : k2; + r3 = (k3 >= nf3) ? k3-nfft3 : k3; h1 = recip[0][0]*r1 + recip[0][1]*r2 + recip[0][2]*r3; h2 = recip[1][0]*r1 + recip[1][1]*r2 + recip[1][2]*r3; h3 = recip[2][0]*r1 + recip[2][1]*r2 + recip[2][2]*r3; @@ -2186,7 +2186,7 @@ void PairAmoeba::polar_kspace() if (term > -50.0 && hsq != 0.0) { denom = volterm*hsq*bsmod1[k1]*bsmod2[k2]*bsmod3[k3]; expterm = exp(term) / denom; - struc2 = qgrid[k3][k2][k1][0]*qgrip[k3][k2][k1][0] + + struc2 = qgrid[k3][k2][k1][0]*qgrip[k3][k2][k1][0] + qgrid[k3][k2][k1][1]*qgrip[k3][k2][k1][1]; eterm = 0.5 * felec * expterm * struc2; vterm = (2.0/hsq) * (1.0-term) * eterm; diff --git a/src/AMOEBA/amoeba_repulsion.cpp b/src/AMOEBA/amoeba_repulsion.cpp index e477941b5c..96e7b31312 100644 --- a/src/AMOEBA/amoeba_repulsion.cpp +++ b/src/AMOEBA/amoeba_repulsion.cpp @@ -115,7 +115,7 @@ void PairAmoeba::repulsion() // DEBUG //FILE *fp = fopen("lammps.dat","w"); - + for (ii = 0; ii < inum; ii++) { i = ilist[ii]; itype = amtype[i]; @@ -138,7 +138,7 @@ void PairAmoeba::repulsion() qiyy = rpole[i][8]; qiyz = rpole[i][9]; qizz = rpole[i][12]; - + for (jj = 0; jj < jnum; jj++) { j = jlist[jj]; factor_repel = special_repel[sbmask15(j)]; @@ -231,11 +231,11 @@ void PairAmoeba::repulsion() dkqirx = dkqiz*yr - dkqiy*zr; dkqiry = dkqix*zr - dkqiz*xr; dkqirz = dkqiy*xr - dkqix*yr; - dqikx = diy*qkz - diz*qky + dky*qiz - dkz*qiy - + dqikx = diy*qkz - diz*qky + dky*qiz - dkz*qiy - 2.0*(qixy*qkxz+qiyy*qkyz+qiyz*qkzz-qixz*qkxy-qiyz*qkyy-qizz*qkyz); - dqiky = diz*qkx - dix*qkz + dkz*qix - dkx*qiz - + dqiky = diz*qkx - dix*qkz + dkz*qix - dkx*qiz - 2.0*(qixz*qkxx+qiyz*qkxy+qizz*qkxz-qixx*qkxz-qixy*qkyz-qixz*qkzz); - dqikz = dix*qky - diy*qkx + dkx*qiy - dky*qix - + dqikz = dix*qky - diy*qkx + dkx*qiy - dky*qix - 2.0*(qixx*qkxy+qixy*qkyy+qixz*qkyz-qixy*qkxx-qiyy*qkxy-qiyz*qkxz); // get reciprocal distance terms for this interaction @@ -258,7 +258,7 @@ void PairAmoeba::repulsion() term3 = vali*qkr + valk*qir - dir*dkr + 2.0*(dkqi-diqk+qiqk); term4 = dir*qkr - dkr*qir - 4.0*qik; term5 = qir*qkr; - eterm = term1*dmpik[0] + term2*dmpik[2] + + eterm = term1*dmpik[0] + term2*dmpik[2] + term3*dmpik[4] + term4*dmpik[6] + term5*dmpik[8]; // compute the Pauli repulsion energy for this interaction @@ -268,7 +268,7 @@ void PairAmoeba::repulsion() // calculate intermediate terms for force and torque - de = term1*dmpik[2] + term2*dmpik[4] + term3*dmpik[6] + + de = term1*dmpik[2] + term2*dmpik[4] + term3*dmpik[6] + term4*dmpik[8] + term5*dmpik[10]; term1 = -valk*dmpik[2] + dkr*dmpik[4] - qkr*dmpik[6]; term2 = vali*dmpik[2] + dir*dmpik[4] + qir*dmpik[6]; @@ -279,11 +279,11 @@ void PairAmoeba::repulsion() // compute the force components for this interaction - frcx = de*xr + term1*dix + term2*dkx + term3*(diqkx-dkqix) + + frcx = de*xr + term1*dix + term2*dkx + term3*(diqkx-dkqix) + term4*qix + term5*qkx + term6*(qixk+qkxi); - frcy = de*yr + term1*diy + term2*dky + term3*(diqky-dkqiy) + + frcy = de*yr + term1*diy + term2*dky + term3*(diqky-dkqiy) + term4*qiy + term5*qky + term6*(qiyk+qkyi); - frcz = de*zr + term1*diz + term2*dkz + term3*(diqkz-dkqiz) + + frcz = de*zr + term1*diz + term2*dkz + term3*(diqkz-dkqiz) + term4*qiz + term5*qkz + term6*(qizk+qkzi); frcx = frcx*rr1 + eterm*rr3*xr; frcy = frcy*rr1 + eterm*rr3*yr; @@ -293,18 +293,18 @@ void PairAmoeba::repulsion() frcz = sizik * frcz; // compute the torque components for this interaction - - ttri[0] = -dmpik[2]*dikx + term1*dirx + term3*(dqikx+dkqirx) - + + ttri[0] = -dmpik[2]*dikx + term1*dirx + term3*(dqikx+dkqirx) - term4*qirx - term6*(qikrx+qikx); - ttri[1] = -dmpik[2]*diky + term1*diry + term3*(dqiky+dkqiry) - + ttri[1] = -dmpik[2]*diky + term1*diry + term3*(dqiky+dkqiry) - term4*qiry - term6*(qikry+qiky); - ttri[2] = -dmpik[2]*dikz + term1*dirz + term3*(dqikz+dkqirz) - + ttri[2] = -dmpik[2]*dikz + term1*dirz + term3*(dqikz+dkqirz) - term4*qirz - term6*(qikrz+qikz); - ttrk[0] = dmpik[2]*dikx + term2*dkrx - term3*(dqikx+diqkrx) - + ttrk[0] = dmpik[2]*dikx + term2*dkrx - term3*(dqikx+diqkrx) - term5*qkrx - term6*(qkirx-qikx); - ttrk[1] = dmpik[2]*diky + term2*dkry - term3*(dqiky+diqkry) - + ttrk[1] = dmpik[2]*diky + term2*dkry - term3*(dqiky+diqkry) - term5*qkry - term6*(qkiry-qiky); - ttrk[2] = dmpik[2]*dikz + term2*dkrz - term3*(dqikz+diqkrz) - + ttrk[2] = dmpik[2]*dikz + term2*dkrz - term3*(dqikz+diqkrz) - term5*qkrz - term6*(qkirz-qikz); ttri[0] = sizik * ttri[0] * rr1; ttri[1] = sizik * ttri[1] * rr1; @@ -371,7 +371,7 @@ void PairAmoeba::repulsion() // energy = e // virial = 6-vec vir // NOTE: add tally function - + if (evflag) { } } @@ -379,7 +379,7 @@ void PairAmoeba::repulsion() // DEBUG //fclose(fp); - + // reverse comm to sum torque from ghost atoms to owned atoms crstyle = TORQUE; @@ -407,11 +407,11 @@ void PairAmoeba::repulsion() vxx = xix*fix[0] + xiy*fiy[0] + xiz*fiz[0]; vyy = yix*fix[1] + yiy*fiy[1] + yiz*fiz[1]; vzz = zix*fix[2] + ziy*fiy[2] + ziz*fiz[2]; - vxy = 0.5 * (yix*fix[0] + yiy*fiy[0] + yiz*fiz[0] + + vxy = 0.5 * (yix*fix[0] + yiy*fiy[0] + yiz*fiz[0] + xix*fix[1] + xiy*fiy[1] + xiz*fiz[1]); - vxz = 0.5 * (zix*fix[0] + ziy*fiy[0] + ziz*fiz[0] + + vxz = 0.5 * (zix*fix[0] + ziy*fiy[0] + ziz*fiz[0] + xix*fix[2] + xiy*fiy[2] + xiz*fiz[2]); - vyz = 0.5 * (zix*fix[1] + ziy*fiy[1] + ziz*fiz[1] + + vyz = 0.5 * (zix*fix[1] + ziy*fiy[1] + ziz*fiz[1] + yix*fix[2] + yiy*fiy[2] + yiz*fiz[2]); virrepulse[0] += vxx; @@ -423,7 +423,7 @@ void PairAmoeba::repulsion() // virial = 6-vec vir // NOTE: add tally function - + if (evflag) { } } @@ -440,7 +440,7 @@ void PairAmoeba::repulsion() 150, 084104 (2019) ------------------------------------------------------------------------- */ -void PairAmoeba::damprep(double r, double r2, double rr1, double rr3, +void PairAmoeba::damprep(double r, double r2, double rr1, double rr3, double rr5, double rr7, double rr9, double rr11, int rorder, double dmpi, double dmpk, double *dmpik) { @@ -519,46 +519,46 @@ void PairAmoeba::damprep(double r, double r2, double rr1, double rr3, tmp = 4.0 * dmpi2 * dmpk2 / term; s = (dampi-tmp)*expk + (dampk+tmp)*expi; - ds = (dmpi2*dmpk2*r2 - 4.0*dmpi2*dmpk22*r/term - - 4.0*dmpi2*dmpk2/term) * expk + + ds = (dmpi2*dmpk2*r2 - 4.0*dmpi2*dmpk22*r/term - + 4.0*dmpi2*dmpk2/term) * expk + (dmpi2*dmpk2*r2 + 4.0*dmpi22*dmpk2*r/term + 4.0*dmpi2*dmpk2/term) * expi; - d2s = (dmpi2*dmpk2*r2/3.0 + dmpi2*dmpk22*r3/3.0 - - (4.0/3.0)*dmpi2*dmpk23*r2/term - 4.0*dmpi2*dmpk22*r/term - - 4.0*dmpi2*dmpk2/term) * expk + - (dmpi2*dmpk2*r2/3.0 + dmpi22*dmpk2*r3/3.0 + - (4.0/3.0)*dmpi23*dmpk2*r2/term + 4.0*dmpi22*dmpk2*r/term + + d2s = (dmpi2*dmpk2*r2/3.0 + dmpi2*dmpk22*r3/3.0 - + (4.0/3.0)*dmpi2*dmpk23*r2/term - 4.0*dmpi2*dmpk22*r/term - + 4.0*dmpi2*dmpk2/term) * expk + + (dmpi2*dmpk2*r2/3.0 + dmpi22*dmpk2*r3/3.0 + + (4.0/3.0)*dmpi23*dmpk2*r2/term + 4.0*dmpi22*dmpk2*r/term + 4.0*dmpi2*dmpk2/term) * expi; - d3s = (dmpi2*dmpk23*r4/15.0 + dmpi2*dmpk22*r3/5.0 + dmpi2*dmpk2*r2/5.0 - - (4.0/15.0)*dmpi2*dmpk24*r3/term - (8.0/5.0)*dmpi2*dmpk23*r2/term - - 4.0*dmpi2*dmpk22*r/term - 4.0/term*dmpi2*dmpk2) * expk + - (dmpi23*dmpk2*r4/15.0 + dmpi22*dmpk2*r3/5.0 + dmpi2*dmpk2*r2/5.0 + - (4.0/15.0)*dmpi24*dmpk2*r3/term + (8.0/5.0)*dmpi23*dmpk2*r2/term + + d3s = (dmpi2*dmpk23*r4/15.0 + dmpi2*dmpk22*r3/5.0 + dmpi2*dmpk2*r2/5.0 - + (4.0/15.0)*dmpi2*dmpk24*r3/term - (8.0/5.0)*dmpi2*dmpk23*r2/term - + 4.0*dmpi2*dmpk22*r/term - 4.0/term*dmpi2*dmpk2) * expk + + (dmpi23*dmpk2*r4/15.0 + dmpi22*dmpk2*r3/5.0 + dmpi2*dmpk2*r2/5.0 + + (4.0/15.0)*dmpi24*dmpk2*r3/term + (8.0/5.0)*dmpi23*dmpk2*r2/term + 4.0*dmpi22*dmpk2*r/term + 4.0/term*dmpi2*dmpk2) * expi; - d4s = (dmpi2*dmpk24*r5/105.0 + (2.0/35.0)*dmpi2*dmpk23*r4 + - dmpi2*dmpk22*r3/7.0 + dmpi2*dmpk2*r2/7.0 - - (4.0/105.0)*dmpi2*dmpk25*r4/term - (8.0/21.0)*dmpi2*dmpk24*r3/term - - (12.0/7.0)*dmpi2*dmpk23*r2/term - 4.0*dmpi2*dmpk22*r/term - - 4.0*dmpi2*dmpk2/term) * expk + - (dmpi24*dmpk2*r5/105.0 + (2.0/35.0)*dmpi23*dmpk2*r4 + - dmpi22*dmpk2*r3/7.0 + dmpi2*dmpk2*r2/7.0 + - (4.0/105.0)*dmpi25*dmpk2*r4/term + (8.0/21.0)*dmpi24*dmpk2*r3/term + - (12.0/7.0)*dmpi23*dmpk2*r2/term + 4.0*dmpi22*dmpk2*r/term + + d4s = (dmpi2*dmpk24*r5/105.0 + (2.0/35.0)*dmpi2*dmpk23*r4 + + dmpi2*dmpk22*r3/7.0 + dmpi2*dmpk2*r2/7.0 - + (4.0/105.0)*dmpi2*dmpk25*r4/term - (8.0/21.0)*dmpi2*dmpk24*r3/term - + (12.0/7.0)*dmpi2*dmpk23*r2/term - 4.0*dmpi2*dmpk22*r/term - + 4.0*dmpi2*dmpk2/term) * expk + + (dmpi24*dmpk2*r5/105.0 + (2.0/35.0)*dmpi23*dmpk2*r4 + + dmpi22*dmpk2*r3/7.0 + dmpi2*dmpk2*r2/7.0 + + (4.0/105.0)*dmpi25*dmpk2*r4/term + (8.0/21.0)*dmpi24*dmpk2*r3/term + + (12.0/7.0)*dmpi23*dmpk2*r2/term + 4.0*dmpi22*dmpk2*r/term + 4.0*dmpi2*dmpk2/term) * expi; - + if (rorder >= 11) { r6 = r5 * r; dmpi26 = dmpi25 * dmpi2; dmpk26 = dmpk25 * dmpk2; - d5s = (dmpi2*dmpk25*r6/945.0 + (2.0/189.0)*dmpi2*dmpk24*r5 + - dmpi2*dmpk23*r4/21.0 + dmpi2*dmpk22*r3/9.0 + dmpi2*dmpk2*r2/9.0 - - (4.0/945.0)*dmpi2*dmpk26*r5/term - - (4.0/63.0)*dmpi2*dmpk25*r4/term - (4.0/9.0)*dmpi2*dmpk24*r3/term - - (16.0/9.0)*dmpi2*dmpk23*r2/term - 4.0*dmpi2*dmpk22*r/term - - 4.0*dmpi2*dmpk2/term) * expk + - (dmpi25*dmpk2*r6/945.0 + (2.0/189.0)*dmpi24*dmpk2*r5 + - dmpi23*dmpk2*r4/21.0 + dmpi22*dmpk2*r3/9.0 + dmpi2*dmpk2*r2/9.0 + - (4.0/945.0)*dmpi26*dmpk2*r5/term + (4.0/63.0)*dmpi25*dmpk2*r4/term + - (4.0/9.0)*dmpi24*dmpk2*r3/term + (16.0/9.0)*dmpi23*dmpk2*r2/term + + d5s = (dmpi2*dmpk25*r6/945.0 + (2.0/189.0)*dmpi2*dmpk24*r5 + + dmpi2*dmpk23*r4/21.0 + dmpi2*dmpk22*r3/9.0 + dmpi2*dmpk2*r2/9.0 - + (4.0/945.0)*dmpi2*dmpk26*r5/term - + (4.0/63.0)*dmpi2*dmpk25*r4/term - (4.0/9.0)*dmpi2*dmpk24*r3/term - + (16.0/9.0)*dmpi2*dmpk23*r2/term - 4.0*dmpi2*dmpk22*r/term - + 4.0*dmpi2*dmpk2/term) * expk + + (dmpi25*dmpk2*r6/945.0 + (2.0/189.0)*dmpi24*dmpk2*r5 + + dmpi23*dmpk2*r4/21.0 + dmpi22*dmpk2*r3/9.0 + dmpi2*dmpk2*r2/9.0 + + (4.0/945.0)*dmpi26*dmpk2*r5/term + (4.0/63.0)*dmpi25*dmpk2*r4/term + + (4.0/9.0)*dmpi24*dmpk2*r3/term + (16.0/9.0)*dmpi23*dmpk2*r2/term + 4.0*dmpi22*dmpk2*r/term + 4.0*dmpi2*dmpk2/term) * expi; } } diff --git a/src/AMOEBA/amoeba_utils.cpp b/src/AMOEBA/amoeba_utils.cpp index 42a9fb7f1f..1b9ce9e8ce 100644 --- a/src/AMOEBA/amoeba_utils.cpp +++ b/src/AMOEBA/amoeba_utils.cpp @@ -111,49 +111,49 @@ void PairAmoeba::kmpole() ztype = zpole[itype][iframe]; for (j12 = 0; j12 < nspecial[i][0]; j12++) { jneigh = bondneigh[j12]; - j = atom->map(jneigh); - if (j < 0) + j = atom->map(jneigh); + if (j < 0) error->one(FLERR,"AMOEBA kmpole() could not find bond partner"); - jtype = amtype[j]; - if (jtype == ztype) { - for (k12 = 0; k12 < nspecial[i][0]; k12++) { - if (k12 == j12) continue; + jtype = amtype[j]; + if (jtype == ztype) { + for (k12 = 0; k12 < nspecial[i][0]; k12++) { + if (k12 == j12) continue; kneigh = bondneigh[k12]; - k = atom->map(kneigh); - if (k < 0) + k = atom->map(kneigh); + if (k < 0) error->one(FLERR,"AMOEBA kmpole() could not find bond partner"); - ktype = amtype[k]; - if (ktype == xtype) { - if (ytype == 0 && !flag) { - flag = 1; - zaxis[i] = jneigh; - xaxis[i] = kneigh; - yaxis[i] = 0; - polaxe[i] = mpaxis[itype][iframe]; - for (j = 0; j < 13; j++) - pole[i][j] = fpole[itype][iframe][j]; - } else { - for (m12 = 0; m12 < nspecial[i][0]; m12++) { - if (m12 == j12 || m12 == k12) continue; + ktype = amtype[k]; + if (ktype == xtype) { + if (ytype == 0 && !flag) { + flag = 1; + zaxis[i] = jneigh; + xaxis[i] = kneigh; + yaxis[i] = 0; + polaxe[i] = mpaxis[itype][iframe]; + for (j = 0; j < 13; j++) + pole[i][j] = fpole[itype][iframe][j]; + } else { + for (m12 = 0; m12 < nspecial[i][0]; m12++) { + if (m12 == j12 || m12 == k12) continue; mneigh = bondneigh[m12]; - m = atom->map(mneigh); - if (m < 0) - error->one(FLERR,"AMOEBA kmpole() could not find bond partner"); - mtype = amtype[m]; - if (mtype == ytype && !flag) { - flag = 1; - zaxis[i] = jneigh; - xaxis[i] = kneigh; - yaxis[i] = mneigh; - polaxe[i] = mpaxis[itype][iframe]; - for (j = 0; j < 13; j++) - pole[i][j] = fpole[itype][iframe][j]; - } - } - } - } - } - } + m = atom->map(mneigh); + if (m < 0) + error->one(FLERR,"AMOEBA kmpole() could not find bond partner"); + mtype = amtype[m]; + if (mtype == ytype && !flag) { + flag = 1; + zaxis[i] = jneigh; + xaxis[i] = kneigh; + yaxis[i] = mneigh; + polaxe[i] = mpaxis[itype][iframe]; + for (j = 0; j < 13; j++) + pole[i][j] = fpole[itype][iframe][j]; + } + } + } + } + } + } } } @@ -167,55 +167,55 @@ void PairAmoeba::kmpole() ztype = zpole[itype][iframe]; for (j12 = 0; j12 < nspecial[i][0]; j12++) { jneigh = bondneigh[j12]; - j = atom->map(jneigh); - if (j < 0) error->one(FLERR,"AMOEBA kmpole() could not find bond partner"); - jtype = amtype[j]; - if (jtype == ztype) { - for (k13 = nspecial[i][0]; k13 < nspecial[i][1]; k13++) { + j = atom->map(jneigh); + if (j < 0) error->one(FLERR,"AMOEBA kmpole() could not find bond partner"); + jtype = amtype[j]; + if (jtype == ztype) { + for (k13 = nspecial[i][0]; k13 < nspecial[i][1]; k13++) { kneigh = angleneigh[k13]; - k = atom->map(kneigh); - if (k < 0) error->one(FLERR,"AMOEBA kmpole() could not find bond partner"); - ktype = amtype[k]; - path = false; - for (m12 = 0; m12 < nspecial[k][0]; m12++) - if (special[k][m12] == jneigh) path = true; - if (!path) continue; - - if (ktype == xtype) { - if (ytype == 0 && !flag) { - flag = 1; - zaxis[i] = jneigh; - xaxis[i] = kneigh; - yaxis[i] = 0; - polaxe[i] = mpaxis[itype][iframe]; - for (j = 0; j < 13; j++) - pole[i][j] = fpole[itype][iframe][j]; - } else { - for (m13 = nspecial[i][0]; m13 < nspecial[i][1]; m13++) { - if (m13 == k13) continue; + k = atom->map(kneigh); + if (k < 0) error->one(FLERR,"AMOEBA kmpole() could not find bond partner"); + ktype = amtype[k]; + path = false; + for (m12 = 0; m12 < nspecial[k][0]; m12++) + if (special[k][m12] == jneigh) path = true; + if (!path) continue; + + if (ktype == xtype) { + if (ytype == 0 && !flag) { + flag = 1; + zaxis[i] = jneigh; + xaxis[i] = kneigh; + yaxis[i] = 0; + polaxe[i] = mpaxis[itype][iframe]; + for (j = 0; j < 13; j++) + pole[i][j] = fpole[itype][iframe][j]; + } else { + for (m13 = nspecial[i][0]; m13 < nspecial[i][1]; m13++) { + if (m13 == k13) continue; mneigh = angleneigh[m13]; - m = atom->map(mneigh); - if (m < 0) - error->one(FLERR,"AMOEBA kmpole() could not find bond partner"); - mtype = amtype[m]; - path = false; - for (m12 = 0; m12 < nspecial[m][0]; m12++) - if (special[m][m12] == jneigh) path = true; - if (!path) continue; - if (mtype == ytype && !flag) { - flag = 1; - zaxis[i] = jneigh; - xaxis[i] = kneigh; - yaxis[i] = mneigh; - polaxe[i] = mpaxis[itype][iframe]; - for (j = 0; j < 13; j++) - pole[i][j] = fpole[itype][iframe][j]; - } - } - } - } - } - } + m = atom->map(mneigh); + if (m < 0) + error->one(FLERR,"AMOEBA kmpole() could not find bond partner"); + mtype = amtype[m]; + path = false; + for (m12 = 0; m12 < nspecial[m][0]; m12++) + if (special[m][m12] == jneigh) path = true; + if (!path) continue; + if (mtype == ytype && !flag) { + flag = 1; + zaxis[i] = jneigh; + xaxis[i] = kneigh; + yaxis[i] = mneigh; + polaxe[i] = mpaxis[itype][iframe]; + for (j = 0; j < 13; j++) + pole[i][j] = fpole[itype][iframe][j]; + } + } + } + } + } + } } } @@ -229,19 +229,19 @@ void PairAmoeba::kmpole() ztype = zpole[itype][iframe]; for (j12 = 0; j12 < nspecial[i][0]; j12++) { jneigh = bondneigh[j12]; - j = atom->map(jneigh); - if (j < 0) error->one(FLERR,"AMOEBA kmpole() could not find bond partner"); - jtype = amtype[j]; - if (jtype == ztype) { - if (xtype == 0 && !flag) { - flag = 1; - zaxis[i] = jtype; - xaxis[i] = yaxis[i] = 0; - polaxe[i] = mpaxis[itype][iframe]; - for (j = 0; j < 13; j++) - pole[i][j] = fpole[itype][iframe][j]; - } - } + j = atom->map(jneigh); + if (j < 0) error->one(FLERR,"AMOEBA kmpole() could not find bond partner"); + jtype = amtype[j]; + if (jtype == ztype) { + if (xtype == 0 && !flag) { + flag = 1; + zaxis[i] = jtype; + xaxis[i] = yaxis[i] = 0; + polaxe[i] = mpaxis[itype][iframe]; + for (j = 0; j < 13; j++) + pole[i][j] = fpole[itype][iframe][j]; + } + } } } @@ -254,11 +254,11 @@ void PairAmoeba::kmpole() ytype = ypole[itype][iframe]; ztype = zpole[itype][iframe]; if (ztype == 0 && !flag) { - flag = 1; - zaxis[i] = xaxis[i] = yaxis[i] = 0; - polaxe[i] = mpaxis[itype][iframe]; - for (j = 0; j < 13; j++) - pole[i][j] = fpole[itype][iframe][j]; + flag = 1; + zaxis[i] = xaxis[i] = yaxis[i] = 0; + polaxe[i] = mpaxis[itype][iframe]; + for (j = 0; j < 13; j++) + pole[i][j] = fpole[itype][iframe][j]; } } @@ -647,7 +647,7 @@ void PairAmoeba::add_onefive_neighbors() list15 = special15[i]; jlist = firstneigh[i]; jnum = numneigh[i]; - + for (jj = 0; jj < jnum; jj++) { j = jlist[jj]; which = j >> SBBITS & 3; @@ -655,12 +655,12 @@ void PairAmoeba::add_onefive_neighbors() jtag = tag[j]; if (!which) { - for (k = 0; k < n15; k++) { - if (list15[k] == jtag) { - which = 4; - break; - } - } + for (k = 0; k < n15; k++) { + if (list15[k] == jtag) { + which = 4; + break; + } + } } if (which) jlist[jj] = j ^ (which << SBBITS15); @@ -792,7 +792,7 @@ void PairAmoeba::find_multipole_neighbors() f = force vector for local atoms, multiple atoms will be updated ------------------------------------------------------------------------- */ -void PairAmoeba::torque2force(int i, double *trq, +void PairAmoeba::torque2force(int i, double *trq, double *frcx, double *frcy, double *frcz, double **f) { diff --git a/src/AMOEBA/angle_amoeba.cpp b/src/AMOEBA/angle_amoeba.cpp index fb59ecb39d..98ee1953da 100644 --- a/src/AMOEBA/angle_amoeba.cpp +++ b/src/AMOEBA/angle_amoeba.cpp @@ -33,7 +33,7 @@ using namespace MathConst; /* ---------------------------------------------------------------------- */ -AngleAmoeba::AngleAmoeba(LAMMPS *lmp) : Angle(lmp) +AngleAmoeba::AngleAmoeba(LAMMPS *lmp) : Angle(lmp) { pflag = nullptr; ubflag = nullptr; @@ -122,11 +122,11 @@ void AngleAmoeba::compute(int eflag, int vflag) tinker_angle(i1,i2,i3,type,eflag); // bondangle = bond-stretch cross term in Tinker - + if (ba_k1[type] != 0.0) tinker_bondangle(i1,i2,i3,type,eflag); } - + // Urey-Bradley H-H bond term within water molecules if (enable_urey) { @@ -162,7 +162,7 @@ void AngleAmoeba::tinker_angle(int i1, int i2, int i3, int type, int eflag) r1 = sqrt(rsq1); // 2nd bond - + delx2 = x[i3][0] - x[i2][0]; dely2 = x[i3][1] - x[i2][1]; delz2 = x[i3][2] - x[i2][2]; @@ -171,7 +171,7 @@ void AngleAmoeba::tinker_angle(int i1, int i2, int i3, int type, int eflag) r2 = sqrt(rsq2); // angle (cos and sin) - + c = delx1*delx2 + dely1*dely2 + delz1*delz2; c /= r1*r2; @@ -181,7 +181,7 @@ void AngleAmoeba::tinker_angle(int i1, int i2, int i3, int type, int eflag) s = sqrt(1.0 - c*c); if (s < SMALL) s = SMALL; s = 1.0/s; - + // force & energy for angle term dtheta = acos(c) - theta0[type]; @@ -198,17 +198,17 @@ void AngleAmoeba::tinker_angle(int i1, int i2, int i3, int type, int eflag) a11 = a*c / rsq1; a12 = -a / (r1*r2); a22 = a*c / rsq2; - + f1[0] = a11*delx1 + a12*delx2; f1[1] = a11*dely1 + a12*dely2; f1[2] = a11*delz1 + a12*delz2; - + f3[0] = a22*delx2 + a12*delx1; f3[1] = a22*dely2 + a12*dely1; f3[2] = a22*delz2 + a12*delz1; eangle = 0.0; - if (eflag) eangle = k2[type]*dtheta2 + k3[type]*dtheta3 + + if (eflag) eangle = k2[type]*dtheta2 + k3[type]*dtheta3 + k4[type]*dtheta4 + k5[type]*dtheta5 + k6[type]*dtheta6; // apply force to each of 3 atoms @@ -261,7 +261,7 @@ void AngleAmoeba::tinker_anglep(int i1, int i2, int i3, int type, int eflag) int newton_bond = force->newton_bond; // i4 = index of third atom that i2 is bonded to - + i1tag = atom->tag[i1]; i3tag = atom->tag[i3]; @@ -329,7 +329,7 @@ void AngleAmoeba::tinker_anglep(int i1, int i2, int i3, int type, int eflag) cosine = MIN(1.0,MAX(-1.0,cosine)); // force & energy for angle term - + dtheta = acos(cosine) - theta0[type]; dtheta2 = dtheta*dtheta; dtheta3 = dtheta2*dtheta; @@ -341,7 +341,7 @@ void AngleAmoeba::tinker_anglep(int i1, int i2, int i3, int type, int eflag) 4.0*k4[type]*dtheta3 + 5.0*k5[type]*dtheta4 + 6.0*k6[type]*dtheta5; eangle = 0.0; - if (eflag) eangle = k2[type]*dtheta2 + k3[type]*dtheta3 + + if (eflag) eangle = k2[type]*dtheta2 + k3[type]*dtheta3 + k4[type]*dtheta4 + k5[type]*dtheta5 + k6[type]*dtheta6; // chain rule terms for first derivative components @@ -445,7 +445,7 @@ void AngleAmoeba::tinker_bondangle(int i1, int i2, int i3, int type, int eflag) r1 = sqrt(rsq1); // 2nd bond - + delx2 = x[i3][0] - x[i2][0]; dely2 = x[i3][1] - x[i2][1]; delz2 = x[i3][2] - x[i2][2]; @@ -454,7 +454,7 @@ void AngleAmoeba::tinker_bondangle(int i1, int i2, int i3, int type, int eflag) r2 = sqrt(rsq2); // angle (cos and sin) - + c = delx1*delx2 + dely1*dely2 + delz1*delz2; c /= r1*r2; @@ -503,7 +503,7 @@ void AngleAmoeba::tinker_bondangle(int i1, int i2, int i3, int type, int eflag) f1[0] = -(vx11 + b1*delx1 + vx12); f1[1] = -(vy11 + b1*dely1 + vy12); f1[2] = -(vz11 + b1*delz1 + vz12); - + f3[0] = -(vx21 + b2*delx2 + vx22); f3[1] = -(vy21 + b2*dely2 + vy22); f3[2] = -(vz21 + b2*delz2 + vz22); @@ -558,7 +558,7 @@ void AngleAmoeba::tinker_urey_bradley(int i1, int i2, int type, int eflag) rk = ub_k[type] * dr; // force & energy - + if (r > 0.0) fbond = -2.0*rk/r; else fbond = 0.0; @@ -610,7 +610,7 @@ void AngleAmoeba::allocate() memory->create(setflag_ba,n+1,"angle:setflag_ba"); memory->create(setflag_ub,n+1,"angle:setflag_ub"); - for (int i = 1; i <= n; i++) + for (int i = 1; i <= n; i++) setflag[i] = setflag_a[i] = setflag_ba[i] = setflag_ub[i] = 0; } @@ -627,7 +627,7 @@ void AngleAmoeba::coeff(int narg, char **arg) utils::bounds(FLERR,arg[0],1,atom->nangletypes,ilo,ihi,error); int count = 0; - + if (strcmp(arg[1],"ba") == 0) { if (narg != 6) error->all(FLERR,"Incorrect args for angle coefficients"); @@ -658,7 +658,7 @@ void AngleAmoeba::coeff(int narg, char **arg) count++; } - } else { + } else { if (narg != 9) error->all(FLERR,"Incorrect args for angle coefficients"); int pflag_one = utils::inumeric(FLERR,arg[1],false,lmp); @@ -671,7 +671,7 @@ void AngleAmoeba::coeff(int narg, char **arg) double k6_one = utils::numeric(FLERR,arg[8],false,lmp); // convert theta0 from degrees to radians - + for (int i = ilo; i <= ihi; i++) { pflag[i] = pflag_one; ubflag[i] = ubflag_one; @@ -689,7 +689,7 @@ void AngleAmoeba::coeff(int narg, char **arg) if (count == 0) error->all(FLERR,"Incorrect args for angle coefficients"); for (int i = ilo; i <= ihi; i++) - if (setflag_a[i] == 1 && setflag_ba[i] == 1 && setflag_ub[i]) + if (setflag_a[i] == 1 && setflag_ba[i] == 1 && setflag_ub[i]) setflag[i] = 1; } diff --git a/src/AMOEBA/atom_vec_amoeba.cpp b/src/AMOEBA/atom_vec_amoeba.cpp index 3bb77ac214..38c1629d32 100644 --- a/src/AMOEBA/atom_vec_amoeba.cpp +++ b/src/AMOEBA/atom_vec_amoeba.cpp @@ -26,7 +26,7 @@ AtomVecAmoeba::AtomVecAmoeba(LAMMPS *lmp) : AtomVec(lmp) atom->molecule_flag = atom->q_flag = 1; atom->nspecial15_flag = 1; - + // strings with peratom variables to include in each AtomVec method // strings cannot contain fields in corresponding AtomVec default strings // order of fields in a string does not matter diff --git a/src/AMOEBA/fix_amoeba_bitorsion.cpp b/src/AMOEBA/fix_amoeba_bitorsion.cpp index 28524df994..55841a4f5b 100644 --- a/src/AMOEBA/fix_amoeba_bitorsion.cpp +++ b/src/AMOEBA/fix_amoeba_bitorsion.cpp @@ -256,7 +256,7 @@ void FixAmoebaBiTorsion::pre_neighbor() if (max_bitorsion_list == 0) { if (nprocs == 1) max_bitorsion_list = nbitorsions; - else max_bitorsion_list = + else max_bitorsion_list = static_cast (LB_FACTOR*nbitorsions/nprocs); memory->create(bitorsion_list,max_bitorsion_list,6, "bitorsion:bitorsion_list"); @@ -559,7 +559,7 @@ void FixAmoebaBiTorsion::post_force(int vflag) dedxu = -dedang1 * (yu*zcb - ycb*zu) / (ru2*rcb); dedyu = -dedang1 * (zu*xcb - zcb*xu) / (ru2*rcb); dedzu = -dedang1 * (xu*ycb - xcb*yu) / (ru2*rcb); - + // compute first derivative components for first angle dedxia = zcb*dedyt - ycb*dedzt; @@ -576,18 +576,18 @@ void FixAmoebaBiTorsion::post_force(int vflag) dedzid = ycb*dedxu - xcb*dedyu; // chain rule terms for second angle derivative components - + xec = xie - xic; yec = yie - yic; zec = zie - zic; - + dedxu2 = dedang2 * (yu*zdc - ydc*zu) / (ru2*rdc); dedyu2 = dedang2 * (zu*xdc - zdc*xu) / (ru2*rdc); dedzu2 = dedang2 * (xu*ydc - xdc*yu) / (ru2*rdc); dedxv2 = -dedang2 * (yv*zdc - ydc*zv) / (rv2*rdc); dedyv2 = -dedang2 * (zv*xdc - zdc*xv) / (rv2*rdc); dedzv2 = -dedang2 * (xv*ydc - xdc*yv) / (rv2*rdc); - + // compute first derivative components for second angle dedxib2 = zdc*dedyu2 - ydc*dedzu2; @@ -662,14 +662,14 @@ void FixAmoebaBiTorsion::post_force(int vflag) vyy2 = ydc*(dedyid2+dedyie2) - ycb*dedyib2 + yed*dedyie2; vzy2 = zdc*(dedyid2+dedyie2) - zcb*dedyib2 + zed*dedyie2; vzz2 = zdc*(dedzid2+dedzie2) - zcb*dedzib2 + zed*dedzie2; - + v[0] += vxx + vxx2; v[1] += vyy + vyy2; v[2] += vzz + vzz2; v[3] += vyx + vyx2; v[4] += vzx + vzx2; v[5] += vzy + vzy2; - + ev_tally(nlist,list,5.0,e,v); } } @@ -735,7 +735,7 @@ void FixAmoebaBiTorsion::read_grid_data(char *bitorsion_file) eof = fgets(line,MAXLINE,fp); eof = fgets(line,MAXLINE,fp); eof = fgets(line,MAXLINE,fp); - if (eof == nullptr) + if (eof == nullptr) error->one(FLERR,"Unexpected end of fix amoeba/bitorsion file"); sscanf(line,"%d",&nbitypes); @@ -762,7 +762,7 @@ void FixAmoebaBiTorsion::read_grid_data(char *bitorsion_file) if (me == 0) { eof = fgets(line,MAXLINE,fp); eof = fgets(line,MAXLINE,fp); - if (eof == nullptr) + if (eof == nullptr) error->one(FLERR,"Unexpected end of fix amoeba/bitorsion file"); sscanf(line,"%d %d %d",&tmp,&nx,&ny); } @@ -782,7 +782,7 @@ void FixAmoebaBiTorsion::read_grid_data(char *bitorsion_file) for (int iy = 0; iy < ny; iy++) { for (int ix = 0; ix < nx; ix++) { eof = fgets(line,MAXLINE,fp); - if (eof == nullptr) + if (eof == nullptr) error->one(FLERR,"Unexpected end of fix amoeba/bitorsion file"); sscanf(line,"%lg %lg %lg",&xgrid,&ygrid,&value); if (iy == 0) ttx[itype][ix] = xgrid; @@ -857,7 +857,7 @@ void FixAmoebaBiTorsion::create_splines() // cyclic = 1 if angle range is -180.0 to 180.0 in both dims // error if cyclic and x,y pairs of edges of 2d array values do not match // equality comparisons are within eps - + int cyclic = 1; double eps = 1.0e-6; @@ -876,19 +876,19 @@ void FixAmoebaBiTorsion::create_splines() // spline fit of derivatives about 1st torsion - for (int i = 0; i < nx; i++) + for (int i = 0; i < nx; i++) tmp1[i] = ttx[itype][i]; for (int j = 0; j < ny; j++) { - for (int i = 0; i < nx; i++) + for (int i = 0; i < nx; i++) tmp2[i] = tbf[itype][j*nx+i]; - if (cyclic) + if (cyclic) cspline(nx-1,tmp1,tmp2,bs,cs,ds,tmp3,tmp4,tmp5,tmp6,tmp7); - else + else nspline(nx-1,tmp1,tmp2,bs,cs,tmp3,tmp4,tmp5,tmp6,tmp7); - for (int i = 0; i < nx; i++) + for (int i = 0; i < nx; i++) tbx[itype][j*nx+i] = bs[i]; } @@ -901,9 +901,9 @@ void FixAmoebaBiTorsion::create_splines() for (int j = 0; j < ny; j++) tmp2[j] = tbf[itype][j*nx+i]; - if (cyclic) + if (cyclic) cspline(ny-1,tmp1,tmp2,bs,cs,ds,tmp3,tmp4,tmp5,tmp6,tmp7); - else + else nspline(ny-1,tmp1,tmp2,bs,cs,tmp3,tmp4,tmp5,tmp6,tmp7); for (int j = 0; j < ny; j++) @@ -919,12 +919,12 @@ void FixAmoebaBiTorsion::create_splines() for (int j = 0; j < ny; j++) tmp2[j] = tbx[itype][j*nx+i]; - if (cyclic) + if (cyclic) cspline(ny-1,tmp1,tmp2,bs,cs,ds,tmp3,tmp4,tmp5,tmp6,tmp7); - else + else nspline(ny-1,tmp1,tmp2,bs,cs,tmp3,tmp4,tmp5,tmp6,tmp7); - for (int j = 0; j < ny; j++) + for (int j = 0; j < ny; j++) tbxy[itype][j*nx+i] = bs[j]; } } @@ -953,9 +953,9 @@ void FixAmoebaBiTorsion::create_splines() rest of args are outputs ------------------------------------------------------------------------- */ -void FixAmoebaBiTorsion::nspline(int n, double *x0, double *y0, +void FixAmoebaBiTorsion::nspline(int n, double *x0, double *y0, double *s1, double *s2, - double *h, double *g, double *dy, + double *h, double *g, double *dy, double *dla, double *dmu) { int i; @@ -982,7 +982,7 @@ void FixAmoebaBiTorsion::nspline(int n, double *x0, double *y0, } // set the initial value via natural boundary condition - + dla[n] = 1.0; dla[0] = 0.0; dmu[n] = 0.0; @@ -1024,9 +1024,9 @@ void FixAmoebaBiTorsion::nspline(int n, double *x0, double *y0, rest of args are outputs ------------------------------------------------------------------------- */ -void FixAmoebaBiTorsion::cspline(int n, double *xn, double *fn, +void FixAmoebaBiTorsion::cspline(int n, double *xn, double *fn, double *b, double *c, double *d, - double *h, double *du, double *dm, + double *h, double *du, double *dm, double *rc, double *rs) { int i; @@ -1038,7 +1038,7 @@ void FixAmoebaBiTorsion::cspline(int n, double *xn, double *fn, // get auxiliary variables and matrix elements on first call - for (i = 0; i < n; i++) + for (i = 0; i < n; i++) h[i] = xn[i+1] - xn[i]; h[n] = h[0]; @@ -1083,7 +1083,7 @@ void FixAmoebaBiTorsion::cspline(int n, double *xn, double *fn, du,cr,rs,x,iflag are outputs ------------------------------------------------------------------------- */ -void FixAmoebaBiTorsion::cytsy(int n, double *dm, double *du, +void FixAmoebaBiTorsion::cytsy(int n, double *dm, double *du, double *cr, double *rs, double *x, int &iflag) { iflag = -2; @@ -1103,14 +1103,14 @@ void FixAmoebaBiTorsion::cytsy(int n, double *dm, double *du, du,cr,iflag are outputs ------------------------------------------------------------------------- */ -void FixAmoebaBiTorsion::cytsyp(int n, double *dm, double *du, +void FixAmoebaBiTorsion::cytsyp(int n, double *dm, double *du, double *cr, int &iflag) { int i; double temp1,temp2; // set error bound and test for condition n greater than 2 - + double eps = 1.0e-8; iflag = -2; @@ -1135,7 +1135,7 @@ void FixAmoebaBiTorsion::cytsyp(int n, double *dm, double *du, return; } - // factoring a while checking for a positive definite and + // factoring a while checking for a positive definite and // strong nonsingular matrix a temp1 = du[1]; @@ -1177,7 +1177,7 @@ void FixAmoebaBiTorsion::cytsyp(int n, double *dm, double *du, dm[n] = dm[n] - dm[n-1]*du[n-1]*du[n-1]; temp1 = 0.0; - for (i = 1; i < n-1; i++) + for (i = 1; i < n-1; i++) temp1 += dm[i]*cr[i]*cr[i]; dm[n] = dm[n] - temp1; @@ -1201,7 +1201,7 @@ void FixAmoebaBiTorsion::cytsyp(int n, double *dm, double *du, rs,x are outputs ------------------------------------------------------------------------- */ -void FixAmoebaBiTorsion::cytsys(int n, double *dm, double *du, +void FixAmoebaBiTorsion::cytsys(int n, double *dm, double *du, double *cr, double *rs, double *x) { int i; @@ -1233,7 +1233,7 @@ void FixAmoebaBiTorsion::cytsys(int n, double *dm, double *du, /* ---------------------------------------------------------------------- ------------------------------------------------------------------------- */ -void FixAmoebaBiTorsion::chkttor(int ib, int ic, int id, +void FixAmoebaBiTorsion::chkttor(int ib, int ic, int id, double &sign, double &value1, double &value2) { } @@ -1245,10 +1245,10 @@ void FixAmoebaBiTorsion::chkttor(int ib, int ic, int id, output = ansy,ansy1,ansy2 ------------------------------------------------------------------------- */ -void FixAmoebaBiTorsion::bcuint1(double *y, double *y1, +void FixAmoebaBiTorsion::bcuint1(double *y, double *y1, double *y2, double *y12, - double x1l, double x1u, double x2l, double x2u, - double x1, double x2, + double x1l, double x1u, double x2l, double x2u, + double x1, double x2, double &ansy, double &ansy1, double &ansy2) { double c[4][4]; @@ -1466,7 +1466,7 @@ void FixAmoebaBiTorsion::write_data_section_size(int /*mth*/, int &nx, int &ny) for (i = 0; i < nlocal; i++) for (m = 0; m < num_bitorsion[i]; m++) if (bitorsion_atom3[i][m] == tag[i]) nx++; - + ny = 6; } diff --git a/src/AMOEBA/fix_amoeba_bitorsion.h b/src/AMOEBA/fix_amoeba_bitorsion.h index b0b85a300d..49a7b5b7ec 100644 --- a/src/AMOEBA/fix_amoeba_bitorsion.h +++ b/src/AMOEBA/fix_amoeba_bitorsion.h @@ -111,9 +111,9 @@ class FixAmoebaBiTorsion : public Fix { void chkttor(int, int, int, double &, double &, double &); void bcuint1(double *, double *, double *, double *, - double, double, double, double, double, double, + double, double, double, double, double, double, double &, double &, double &); - void bcucof(double *, double *, double *, double *, double, double, + void bcucof(double *, double *, double *, double *, double, double, double [][4]); }; diff --git a/src/AMOEBA/fix_amoeba_pitorsion.cpp b/src/AMOEBA/fix_amoeba_pitorsion.cpp index f386c1b005..369c191963 100644 --- a/src/AMOEBA/fix_amoeba_pitorsion.cpp +++ b/src/AMOEBA/fix_amoeba_pitorsion.cpp @@ -222,7 +222,7 @@ void FixAmoebaPiTorsion::pre_neighbor() if (max_pitorsion_list == 0) { if (nprocs == 1) max_pitorsion_list = npitorsions; - else max_pitorsion_list = + else max_pitorsion_list = static_cast (LB_FACTOR*npitorsions/nprocs); memory->create(pitorsion_list,max_pitorsion_list,7, "pitorsion:pitorsion_list"); @@ -423,7 +423,7 @@ void FixAmoebaPiTorsion::post_force(int vflag) sine = (xdc*xtu + ydc*ytu + zdc*ztu) / (rdc*rtru); // set the pi-system torsion parameters for this angle - + v2 = kpit[ptype]; c2 = -1.0; s2 = 0.0; @@ -625,11 +625,11 @@ void FixAmoebaPiTorsion::read_data_section(char *keyword, int n, char *buf, sscanf(keyword,"%d",&npitorsion_types); which = 1; } else error->all(FLERR,"Invalid read data section for fix amoeba/pitorsion"); - + // loop over lines of PiTorsion Coeffs // tokenize the line into values // initialize kpit vector - + if (which == 1) { int itype; double value; @@ -662,7 +662,7 @@ void FixAmoebaPiTorsion::read_data_section(char *keyword, int n, char *buf, *next = '\0'; int nwords = utils::count_words(utils::trim_comment(buf)); *next = '\n'; - + if (nwords != 8) error->all(FLERR,"Incorrect {} format in data file",keyword); @@ -692,7 +692,7 @@ void FixAmoebaPiTorsion::read_data_section(char *keyword, int n, char *buf, pitorsion_atom6[m][num_pitorsion[m]] = atom6; num_pitorsion[m]++; } - + if ((m = atom->map(atom2)) >= 0) { if (num_pitorsion[m] == PITORSIONMAX) error->one(FLERR,"Too many PiTorsions for one atom"); @@ -705,7 +705,7 @@ void FixAmoebaPiTorsion::read_data_section(char *keyword, int n, char *buf, pitorsion_atom6[m][num_pitorsion[m]] = atom6; num_pitorsion[m]++; } - + if ((m = atom->map(atom3)) >= 0) { if (num_pitorsion[m] == PITORSIONMAX) error->one(FLERR,"Too many PiTorsions for one atom"); @@ -731,7 +731,7 @@ void FixAmoebaPiTorsion::read_data_section(char *keyword, int n, char *buf, pitorsion_atom6[m][num_pitorsion[m]] = atom6; num_pitorsion[m]++; } - + if ((m = atom->map(atom5)) >= 0) { if (num_pitorsion[m] == PITORSIONMAX) error->one(FLERR,"Too many PiTorsions for one atom"); @@ -744,7 +744,7 @@ void FixAmoebaPiTorsion::read_data_section(char *keyword, int n, char *buf, pitorsion_atom6[m][num_pitorsion[m]] = atom6; num_pitorsion[m]++; } - + if ((m = atom->map(atom6)) >= 0) { if (num_pitorsion[m] == PITORSIONMAX) error->one(FLERR,"Too many PiTorsions for one atom"); @@ -757,7 +757,7 @@ void FixAmoebaPiTorsion::read_data_section(char *keyword, int n, char *buf, pitorsion_atom6[m][num_pitorsion[m]] = atom6; num_pitorsion[m]++; } - + buf = next + 1; } } @@ -780,7 +780,7 @@ bigint FixAmoebaPiTorsion::read_data_skip_lines(char *keyword) void FixAmoebaPiTorsion::write_data_header(FILE *fp, int mth) { if (mth == 0) fprintf(fp,BIGINT_FORMAT " pitorsions\n",npitorsions); - else if (mth == 1) + else if (mth == 1) fprintf(fp,BIGINT_FORMAT " pitorsion types\n",npitorsion_types); } @@ -898,7 +898,7 @@ void FixAmoebaPiTorsion::write_data_section(int mth, FILE *fp, if (mth == 0) { for (int i = 0; i < n; i++) fprintf(fp,"%d %d " TAGINT_FORMAT " " TAGINT_FORMAT - " " TAGINT_FORMAT " " TAGINT_FORMAT " " TAGINT_FORMAT + " " TAGINT_FORMAT " " TAGINT_FORMAT " " TAGINT_FORMAT " " TAGINT_FORMAT "\n", index+i,(int) ubuf(buf[i][0]).i,(tagint) ubuf(buf[i][1]).i, (tagint) ubuf(buf[i][2]).i,(tagint) ubuf(buf[i][3]).i, diff --git a/src/AMOEBA/improper_amoeba.cpp b/src/AMOEBA/improper_amoeba.cpp index 73062505f3..ad7e26d97e 100644 --- a/src/AMOEBA/improper_amoeba.cpp +++ b/src/AMOEBA/improper_amoeba.cpp @@ -127,9 +127,9 @@ void ImproperAmoeba::compute(int eflag, int vflag) xcd = xic - xid; ycd = yic - yid; zcd = zic - zid; - + // Allinger angle between A-C-D plane and D-B vector for D-B < AC - + rad2 = xad*xad + yad*yad + zad*zad; rcd2 = xcd*xcd + ycd*ycd + zcd*zcd; dot = xad*xcd + yad*ycd + zad*zcd; @@ -152,12 +152,12 @@ void ImproperAmoeba::compute(int eflag, int vflag) dt2 = dt * dt; dt3 = dt2 * dt; dt4 = dt2 * dt2; - e = eprefactor * k[type] * dt2 * - (1.0 + opbend_cubic*dt + opbend_quartic*dt2 + + e = eprefactor * k[type] * dt2 * + (1.0 + opbend_cubic*dt + opbend_quartic*dt2 + opbend_pentic*dt3 + opbend_sextic*dt4); - deddt = fprefactor * k[type] * dt * - (2.0 + 3.0*opbend_cubic*dt + 4.0*opbend_quartic*dt2 + + deddt = fprefactor * k[type] * dt * + (2.0 + 3.0*opbend_cubic*dt + 4.0*opbend_quartic*dt2 + 5.0*opbend_pentic*dt3 + 6.0*opbend_sextic*dt4); sign = (ee >= 0.0) ? 1.0 : -1.0; dedcos = -deddt * sign / sqrt(cc*rdb2 - ee*ee); diff --git a/src/AMOEBA/pair_amoeba.cpp b/src/AMOEBA/pair_amoeba.cpp index ebf4a19bc6..2203c220ff 100644 --- a/src/AMOEBA/pair_amoeba.cpp +++ b/src/AMOEBA/pair_amoeba.cpp @@ -56,7 +56,7 @@ PairAmoeba::PairAmoeba(LAMMPS *lmp) : Pair(lmp) { // error checks - if (strcmp(update->unit_style,"real") != 0) + if (strcmp(update->unit_style,"real") != 0) error->all(FLERR,"Pair style amoeba/hippo require real units"); if (force->newton_pair == 0) error->all(FLERR,"Pair style amoeba/hippo require newton pair on"); @@ -65,7 +65,7 @@ PairAmoeba::PairAmoeba(LAMMPS *lmp) : Pair(lmp) me = comm->me; nprocs = comm->nprocs; - + // force field settings one_coeff = 1; @@ -77,7 +77,7 @@ PairAmoeba::PairAmoeba(LAMMPS *lmp) : Pair(lmp) optorder = 0; maxualt = 0; tcgnab = 0; - + nmax = 0; xaxis2local = yaxis2local = zaxis2local = NULL; rpole = NULL; @@ -102,7 +102,7 @@ PairAmoeba::PairAmoeba(LAMMPS *lmp) : Pair(lmp) m_kspace = p_kspace = pc_kspace = d_kspace = NULL; i_kspace = ic_kspace = NULL; - + numneigh_dipole = NULL; firstneigh_dipole = NULL; firstneigh_dipdip = NULL; @@ -135,7 +135,7 @@ PairAmoeba::PairAmoeba(LAMMPS *lmp) : Pair(lmp) //electric = force->qqr2e; // factors for FFT grid size - + nfactors = 3; factors = new int[nfactors]; factors[0] = 2; @@ -265,7 +265,7 @@ void PairAmoeba::compute(int eflag, int vflag) if (atom->nlocal + atom->nghost > nmax) grow_local(); // set amtype/amgroup ptrs for rest of compute() to use it - + amtype = atom->ivector[index_amtype]; amgroup = atom->ivector[index_amgroup]; @@ -275,27 +275,27 @@ void PairAmoeba::compute(int eflag, int vflag) // ------------------------------------------------------------------- // assignment of atoms to polarization groups - + if (first_flag_compute) assign_groups(); // assigmment of multipole neighbors to each owned atom // sets xaxis,yaxis,zaxis // for HIPPO, also set pval for each atom, then ghost comm of pval - + if (first_flag_compute) { cfstyle = KMPOLE; comm->forward_comm_pair(this); kmpole(); - + if (hippo) { pval = atom->dvector[index_pval]; double **pole = fixpole->astore; int nlocal = atom->nlocal; int itype,iclass; for (int i = 0; i < nlocal; i++) { - itype = amtype[i]; - iclass = amtype2class[itype]; - pval[i] = pole[i][0] - pcore[iclass]; + itype = amtype[i]; + iclass = amtype2class[itype]; + pval[i] = pole[i][0] - pcore[iclass]; } cfstyle = PVAL; comm->forward_comm_pair(this); @@ -328,7 +328,7 @@ void PairAmoeba::compute(int eflag, int vflag) // reset KSpace recip matrix if box size/shape change dynamically if (domain->box_change) lattice(); - + // compute reduced H coords for owned atoms // needs to be computed before forward_comm with cfstyle = SETUP @@ -345,7 +345,7 @@ void PairAmoeba::compute(int eflag, int vflag) rdn = kred[iclass]; xred[i][0] = rdn*(x[i][0]-x[j][0]) + x[j][0]; xred[i][1] = rdn*(x[i][1]-x[j][1]) + x[j][1]; - xred[i][2] = rdn*(x[i][2]-x[j][2]) + x[j][2]; + xred[i][2] = rdn*(x[i][2]-x[j][2]) + x[j][2]; } } @@ -424,14 +424,14 @@ void PairAmoeba::compute(int eflag, int vflag) int nall = nlocal + atom->nghost; for (int i = 0; i < 6; i++) - virial[i] = virhal[i] + virrepulse[i] + virdisp[i] + + virial[i] = virhal[i] + virrepulse[i] + virdisp[i] + virpolar[i] + virmpole[i] + virqxfer[i]; // virial computation // NOTE: how does this work for AMOEBA ? // do all terms get summed this way, or only pairwise // it is 2x what summed virial[6] above is - + // if (vflag_fdotr) virial_fdotr_compute(); // timing information @@ -527,7 +527,7 @@ void PairAmoeba::allocate() void PairAmoeba::settings(int narg, char **arg) { // turn on all FF components by default - + hal_flag = repulse_flag = qxfer_flag = 1; disp_rspace_flag = disp_kspace_flag = 1; polar_rspace_flag = polar_kspace_flag = 1; @@ -565,15 +565,15 @@ void PairAmoeba::settings(int narg, char **arg) if (strcmp(arg[iarg],"hal") == 0) hal_flag = newvalue; else if (strcmp(arg[iarg],"repulse") == 0) repulse_flag = newvalue; else if (strcmp(arg[iarg],"qxfer") == 0) qxfer_flag = newvalue; - else if (strcmp(arg[iarg],"disp") == 0) + else if (strcmp(arg[iarg],"disp") == 0) disp_rspace_flag = disp_kspace_flag = newvalue; else if (strcmp(arg[iarg],"disp/rspace") == 0) disp_rspace_flag = newvalue; else if (strcmp(arg[iarg],"disp/kspace") == 0) disp_kspace_flag = newvalue; - else if (strcmp(arg[iarg],"polar") == 0) + else if (strcmp(arg[iarg],"polar") == 0) polar_rspace_flag = polar_kspace_flag = newvalue; else if (strcmp(arg[iarg],"polar/rspace") == 0) polar_rspace_flag = newvalue; else if (strcmp(arg[iarg],"polar/kspace") == 0) polar_kspace_flag = newvalue; - else if (strcmp(arg[iarg],"mpole") == 0) + else if (strcmp(arg[iarg],"mpole") == 0) mpole_rspace_flag = mpole_kspace_flag = newvalue; else if (strcmp(arg[iarg],"mpole/rspace") == 0) mpole_rspace_flag = newvalue; else if (strcmp(arg[iarg],"mpole/kspace") == 0) mpole_kspace_flag = newvalue; @@ -693,44 +693,44 @@ void PairAmoeba::init_style() if (apewald == aeewald && polar_kspace_flag && !mpole_kspace_flag) error->all(FLERR, - "Pair amoeba with apewald = aeewald requires mpole and polar together"); - + "Pair amoeba with apewald = aeewald requires mpole and polar together"); + // check if all custom atom arrays were set via fix property/atom int flag,cols; index_amtype = atom->find_custom("amtype",flag,cols); - if (index_amtype < 0 || flag || cols) + if (index_amtype < 0 || flag || cols) error->all(FLERR,"Pair amoeba amtype is not defined"); index_amgroup = atom->find_custom("amgroup",flag,cols); - if (index_amgroup < 0 || flag || cols) + if (index_amgroup < 0 || flag || cols) error->all(FLERR,"Pair amoeba amgroup is not defined"); - + index_ired = atom->find_custom("ired",flag,cols); - if (index_ired < 0 || flag || cols) + if (index_ired < 0 || flag || cols) error->all(FLERR,"Pair amoeba ired is not defined"); index_xaxis = atom->find_custom("xaxis",flag,cols); - if (index_xaxis < 0 || flag || cols) + if (index_xaxis < 0 || flag || cols) error->all(FLERR,"Pair amoeba xaxis is not defined"); index_yaxis = atom->find_custom("yaxis",flag,cols); - if (index_yaxis < 0 || flag || cols) + if (index_yaxis < 0 || flag || cols) error->all(FLERR,"Pair amoeba yaxis is not defined"); index_zaxis = atom->find_custom("zaxis",flag,cols); - if (index_zaxis < 0 || flag || cols) + if (index_zaxis < 0 || flag || cols) error->all(FLERR,"Pair amoeba zaxis is not defined"); - + index_polaxe = atom->find_custom("polaxe",flag,cols); - if (index_polaxe < 0 || flag || cols) + if (index_polaxe < 0 || flag || cols) error->all(FLERR,"Pair amoeba polaxe is not defined"); index_pval = atom->find_custom("pval",flag,cols); - if (index_pval < 0 || !flag || cols) + if (index_pval < 0 || !flag || cols) error->all(FLERR,"Pair amoeba pval is not defined"); // ------------------------------------------------------------------- // one-time initializations // can't do earlier b/c need all atoms to exist // ------------------------------------------------------------------- - + // creation of per-atom storage // create a new fix STORE style for each atom's pole vector // id = "AMOEBA_pole", fix group = all @@ -815,24 +815,24 @@ void PairAmoeba::init_style() // initialize KSpace Ewald settings and FFTs and parallel grid objects // Coulombic grid is used with two orders: bseorder and bsporder // so need two GridComm instantiations for ghost comm - + if (first_flag) { kewald(); if (use_ewald) { m_kspace = - new AmoebaConvolution(lmp,this,nefft1,nefft2,nefft3,bseorder,MPOLE_GRID); + new AmoebaConvolution(lmp,this,nefft1,nefft2,nefft3,bseorder,MPOLE_GRID); p_kspace = - new AmoebaConvolution(lmp,this,nefft1,nefft2,nefft3,bsporder,POLAR_GRID); + new AmoebaConvolution(lmp,this,nefft1,nefft2,nefft3,bsporder,POLAR_GRID); pc_kspace = - new AmoebaConvolution(lmp,this,nefft1,nefft2,nefft3,bsporder,POLAR_GRIDC); + new AmoebaConvolution(lmp,this,nefft1,nefft2,nefft3,bsporder,POLAR_GRIDC); i_kspace = - new AmoebaConvolution(lmp,this,nefft1,nefft2,nefft3,bsporder,INDUCE_GRID); + new AmoebaConvolution(lmp,this,nefft1,nefft2,nefft3,bsporder,INDUCE_GRID); ic_kspace = - new AmoebaConvolution(lmp,this,nefft1,nefft2,nefft3,bsporder,INDUCE_GRIDC); + new AmoebaConvolution(lmp,this,nefft1,nefft2,nefft3,bsporder,INDUCE_GRIDC); } if (use_dewald) { d_kspace = - new AmoebaConvolution(lmp,this,ndfft1,ndfft2,ndfft3,bsdorder,DISP_GRID); + new AmoebaConvolution(lmp,this,ndfft1,ndfft2,ndfft3,bsdorder,DISP_GRID); } } @@ -861,7 +861,7 @@ void PairAmoeba::init_style() csixpr = 0.0; for (int i = 1; i <= n_amclass; i++) { for (int j = i+1; j <= n_amclass; j++) { - csixpr += csix[i]*csix[j] * csix_num[i]*csix_num[j]; + csixpr += csix[i]*csix[j] * csix_num[i]*csix_num[j]; } } csixpr *= 2.0; @@ -882,9 +882,9 @@ void PairAmoeba::init_style() int nlocal = atom->nlocal; for (int i = 0; i < nlocal; i++) pval[i] = 0.0; } - + // output FF settings to screen and logfile - + if (first_flag) { if (comm->me == 0) { if (screen) print_settings(screen); @@ -893,7 +893,7 @@ void PairAmoeba::init_style() } // all done with one-time initializations - + first_flag = 0; // ------------------------------------------------------------------- @@ -998,14 +998,14 @@ void PairAmoeba::print_settings(FILE *fp) sqrt(off2),sqrt(cut2), special_repel[1],special_repel[2],special_repel[3],special_repel[4]); } - + if (hippo) { choose(QFER); fprintf(fp," qxfer: cut %g taper %g mscale %g %g %g %g\n", sqrt(off2),sqrt(cut2), special_mpole[1],special_mpole[2],special_mpole[3],special_mpole[4]); } - + if (hippo) { if (use_dewald) { choose(DISP_LONG); @@ -1020,47 +1020,47 @@ void PairAmoeba::print_settings(FILE *fp) special_disp[1],special_disp[2],special_disp[3],special_disp[4]); } } - + if (use_ewald) { choose(MPOLE_LONG); fprintf(fp," multipole: cut %g aewald %g bsorder %d " - "FFT %d %d %d mscale %g %g %g %g\n", - sqrt(off2),aewald,bseorder,nefft1,nefft2,nefft3, - special_mpole[1],special_mpole[2],special_mpole[3],special_mpole[4]); + "FFT %d %d %d mscale %g %g %g %g\n", + sqrt(off2),aewald,bseorder,nefft1,nefft2,nefft3, + special_mpole[1],special_mpole[2],special_mpole[3],special_mpole[4]); } else { choose(MPOLE); fprintf(fp," multipole: cut %g aewald %g mscale %g %g %g %g\n", - sqrt(off2),aewald, - special_mpole[1],special_mpole[2],special_mpole[3],special_mpole[4]); + sqrt(off2),aewald, + special_mpole[1],special_mpole[2],special_mpole[3],special_mpole[4]); } - + if (use_ewald) { choose(POLAR_LONG); fprintf(fp," polar: cut %g aewald %g bsorder %d FFT %d %d %d\n", - sqrt(off2),aewald,bsporder,nefft1,nefft2,nefft3); + sqrt(off2),aewald,bsporder,nefft1,nefft2,nefft3); fprintf(fp," pscale %g %g %g %g piscale %g %g %g %g " - "wscale %g %g %g %g d/u scale %g %g\n", - special_polar_pscale[1],special_polar_pscale[2], - special_polar_pscale[3],special_polar_pscale[4], - special_polar_piscale[1],special_polar_piscale[2], - special_polar_piscale[3],special_polar_piscale[4], - special_polar_wscale[1],special_polar_wscale[2], - special_polar_wscale[3],special_polar_wscale[4], - polar_dscale,polar_uscale); + "wscale %g %g %g %g d/u scale %g %g\n", + special_polar_pscale[1],special_polar_pscale[2], + special_polar_pscale[3],special_polar_pscale[4], + special_polar_piscale[1],special_polar_piscale[2], + special_polar_piscale[3],special_polar_piscale[4], + special_polar_wscale[1],special_polar_wscale[2], + special_polar_wscale[3],special_polar_wscale[4], + polar_dscale,polar_uscale); } else { choose(POLAR); fprintf(fp," polar: cut %g aewald %g\n",sqrt(off2),aewald); fprintf(fp," pscale %g %g %g %g piscale %g %g %g %g " - "wscale %g %g %g %g d/u scale %g %g\n", - special_polar_pscale[1],special_polar_pscale[2], - special_polar_pscale[3],special_polar_pscale[4], - special_polar_piscale[1],special_polar_piscale[2], - special_polar_piscale[3],special_polar_piscale[4], - special_polar_wscale[1],special_polar_wscale[2], - special_polar_wscale[3],special_polar_wscale[4], - polar_dscale,polar_uscale); + "wscale %g %g %g %g d/u scale %g %g\n", + special_polar_pscale[1],special_polar_pscale[2], + special_polar_pscale[3],special_polar_pscale[4], + special_polar_piscale[1],special_polar_piscale[2], + special_polar_piscale[3],special_polar_piscale[4], + special_polar_wscale[1],special_polar_wscale[2], + special_polar_wscale[3],special_polar_wscale[4], + polar_dscale,polar_uscale); } - + choose(USOLV); fprintf(fp," precondition: cut %g\n",sqrt(off2)); } @@ -1606,7 +1606,7 @@ void PairAmoeba::assign_groups() // initially, groupID = atomID // communicate new groupIDs to ghost atoms - + for (i = 0; i < nlocal; i++) amgroup[i] = tag[i]; cfstyle = AMGROUP; comm->forward_comm_pair(this); @@ -1616,81 +1616,81 @@ void PairAmoeba::assign_groups() while (1) { // loop over all atoms and their group neighborhoods - + ghostmark = 0; for (i = 0; i < nlocal; i++) { // push atom I on stack - + nstack = 0; if (nstack == maxstack) { - maxstack += DELTASTACK; - memory->grow(stack,maxstack,"amoeba:stack"); + maxstack += DELTASTACK; + memory->grow(stack,maxstack,"amoeba:stack"); } stack[nstack++] = i; // loop over I's group neighborhood until stack is empty - + while (nstack > 0) { - // pop atom M off stack - - m = stack[nstack-1]; - nstack--; - mtype = amtype[m]; + // pop atom M off stack - // loop over bond partners of atom M - - nbond = nspecial[m][0]; - for (ibond = 0; ibond < nbond; ibond++) { - jglobal = special[m][ibond]; - j = atom->map(jglobal); - if (j < 0) - error->one(FLERR,"AMOEBA group assignment bond neighbor not found"); - jtype = amtype[j]; + m = stack[nstack-1]; + nstack--; + mtype = amtype[m]; - // if amtype of bondpartner J is not in polgroup of atom M, continue - - ngroup = npolgroup[mtype]; - for (igroup = 0; igroup < ngroup; igroup++) - if (jtype == polgroup[mtype][igroup]) break; - if (igroup == ngroup) continue; - - // if groupID of atoms J and M are the same, continue - // else set atom with larger groupID to smaller groupID - // if changed atom is ghost, set ghostmark, else push atom on stack - - if (amgroup[m] == amgroup[j]) continue; + // loop over bond partners of atom M - if (amgroup[m] > amgroup[j]) { - amgroup[m] = amgroup[j]; - if (nstack == maxstack) { - maxstack += DELTASTACK; - memory->grow(stack,maxstack,"amoeba:stack"); - } - stack[nstack++] = m; - } else { - amgroup[j] = amgroup[m]; - if (j >= nlocal) ghostmark = 1; - else { - if (nstack == maxstack) { - maxstack += DELTASTACK; - memory->grow(stack,maxstack,"amoeba:stack"); - } - stack[nstack++] = j; - } - } - } + nbond = nspecial[m][0]; + for (ibond = 0; ibond < nbond; ibond++) { + jglobal = special[m][ibond]; + j = atom->map(jglobal); + if (j < 0) + error->one(FLERR,"AMOEBA group assignment bond neighbor not found"); + jtype = amtype[j]; + + // if amtype of bondpartner J is not in polgroup of atom M, continue + + ngroup = npolgroup[mtype]; + for (igroup = 0; igroup < ngroup; igroup++) + if (jtype == polgroup[mtype][igroup]) break; + if (igroup == ngroup) continue; + + // if groupID of atoms J and M are the same, continue + // else set atom with larger groupID to smaller groupID + // if changed atom is ghost, set ghostmark, else push atom on stack + + if (amgroup[m] == amgroup[j]) continue; + + if (amgroup[m] > amgroup[j]) { + amgroup[m] = amgroup[j]; + if (nstack == maxstack) { + maxstack += DELTASTACK; + memory->grow(stack,maxstack,"amoeba:stack"); + } + stack[nstack++] = m; + } else { + amgroup[j] = amgroup[m]; + if (j >= nlocal) ghostmark = 1; + else { + if (nstack == maxstack) { + maxstack += DELTASTACK; + memory->grow(stack,maxstack,"amoeba:stack"); + } + stack[nstack++] = j; + } + } + } } } // communicate new groupIDs to ghost atoms - + cfstyle = AMGROUP; comm->forward_comm_pair(this); // done if no proc reset groupID of a ghost atom - + MPI_Allreduce(&ghostmark,&anyghostmark,1,MPI_INT,MPI_MAX,world); if (!anyghostmark) break; } @@ -1721,7 +1721,7 @@ void PairAmoeba::assign_groups() void PairAmoeba::pbc_xred() { double prd,prd_half,delta; - + double **x = atom->x; int nlocal = atom->nlocal; int nall = nlocal + atom->nghost; @@ -1732,9 +1732,9 @@ void PairAmoeba::pbc_xred() for (int i = nlocal; i < nall; i++) { delta = xred[i][0] - x[i][0]; while (fabs(delta) > prd_half) { - if (delta < 0.0) xred[i][0] += prd; - else xred[i][0] -= prd; - delta = xred[i][0] - x[i][0]; + if (delta < 0.0) xred[i][0] += prd; + else xred[i][0] -= prd; + delta = xred[i][0] - x[i][0]; } } } @@ -1745,22 +1745,22 @@ void PairAmoeba::pbc_xred() for (int i = nlocal; i < nall; i++) { delta = xred[i][1] - x[i][1]; while (fabs(delta) > prd_half) { - if (delta < 0.0) xred[i][1] += prd; - else xred[i][1] -= prd; - delta = xred[i][1] - x[i][1]; + if (delta < 0.0) xred[i][1] += prd; + else xred[i][1] -= prd; + delta = xred[i][1] - x[i][1]; } } } - + if (domain->zperiodic) { prd = domain->zprd; prd_half = domain->zprd_half; for (int i = nlocal; i < nall; i++) { delta = xred[i][2] - x[i][2]; while (fabs(delta) > prd_half) { - if (delta < 0.0) xred[i][2] += prd; - else xred[i][2] -= prd; - delta = xred[i][2] - x[i][2]; + if (delta < 0.0) xred[i][2] += prd; + else xred[i][2] -= prd; + delta = xred[i][2] - x[i][2]; } } } @@ -1846,7 +1846,7 @@ void PairAmoeba::allocate_vdwl() memory->create(epsilon,n_amclass+1,n_amclass+1,"amoeba:epsilon"); memory->create(epsilon4,n_amclass+1,n_amclass+1,"amoeba:epsilon4"); } - + void PairAmoeba::deallocate_vdwl() { memory->destroy(radmin); @@ -1922,7 +1922,7 @@ void PairAmoeba::choose(int which) double off,cut; // short-range only terms - + if (which == HAL) { off = vdwcut; cut = vdwtaper; @@ -1949,7 +1949,7 @@ void PairAmoeba::choose(int which) cut = 0.99*off; // not used // short-range + long-range terms - + } else if (which == DISP_LONG) { off = dispcut; cut = 0.99*cut; // not used @@ -1963,7 +1963,7 @@ void PairAmoeba::choose(int which) cut = 0.99*off; // not used aewald = apewald; } - + off2 = off*off; cut2 = cut*cut; @@ -1993,16 +1993,16 @@ void PairAmoeba::mix() double TWOSIX = pow(2.0,1.0/6.0); for (i = 1; i <= n_amclass; i++) { - + // printf("MIX i %d nclass %d eps %g sigma %g\n", // i,n_amclass,vdwl_eps[i],vdwl_sigma[i]); - + for (j = i; j <= n_amclass; j++) { ei = vdwl_eps[i]; ej = vdwl_eps[j]; ri = vdwl_sigma[i]; rj = vdwl_sigma[j]; - + if (radius_type == SIGMA) { ri *= TWOSIX; rj *= TWOSIX; @@ -2011,7 +2011,7 @@ void PairAmoeba::mix() ri *= 0.5; rj *= 0.5; } - + sri = sqrt(ri); ei = fabs(ei); sei = sqrt(ei); @@ -2061,7 +2061,7 @@ void PairAmoeba::mix() j = vdwl_class_pair[m][1]; rij = vdwl_sigma_pair[m]; eij = vdwl_eps_pair[m]; - + if (radius_type == SIGMA) rij *= TWOSIX; radmin[j][i] = radmin[i][j] = rij; @@ -2217,12 +2217,12 @@ void PairAmoeba::grow_local() ------------------------------------------------------------------------- */ void PairAmoeba::dump6(FILE *fp, const char *columns, double scale, - double **a, double **b) + double **a, double **b) { int i,j,m; MPI_Status status; MPI_Request request; - + // setup int size_one = 7; @@ -2253,7 +2253,7 @@ void PairAmoeba::dump6(FILE *fp, const char *columns, double scale, } // write file - + if (me == 0) { fprintf(fp,"ITEM: TIMESTEP\n"); fprintf(fp,BIGINT_FORMAT "\n",update->ntimestep); @@ -2268,25 +2268,25 @@ void PairAmoeba::dump6(FILE *fp, const char *columns, double scale, int nlines; double tmp; - + if (me == 0) { for (int iproc = 0; iproc < nprocs; iproc++) { if (iproc) { - MPI_Irecv(buf,maxlocal*size_one,MPI_DOUBLE,iproc,0,world,&request); - MPI_Send(&tmp,0,MPI_INT,iproc,0,world); - MPI_Wait(&request,&status); - MPI_Get_count(&status,MPI_DOUBLE,&nlines); - nlines /= size_one; + MPI_Irecv(buf,maxlocal*size_one,MPI_DOUBLE,iproc,0,world,&request); + MPI_Send(&tmp,0,MPI_INT,iproc,0,world); + MPI_Wait(&request,&status); + MPI_Get_count(&status,MPI_DOUBLE,&nlines); + nlines /= size_one; } else nlines = nlocal; - + m = 0; for (i = 0; i < nlines; i++) { - for (j = 0; j < size_one; j++) { - if (j == 0) fprintf(fp,"%d",static_cast (buf[m])); - else fprintf(fp," %g",buf[m]); - m++; - } - fprintf(fp,"\n"); + for (j = 0; j < size_one; j++) { + if (j == 0) fprintf(fp,"%d",static_cast (buf[m])); + else fprintf(fp," %g",buf[m]); + m++; + } + fprintf(fp,"\n"); } } diff --git a/src/AMOEBA/pair_amoeba.h b/src/AMOEBA/pair_amoeba.h index faaedb34ed..3595a5920b 100644 --- a/src/AMOEBA/pair_amoeba.h +++ b/src/AMOEBA/pair_amoeba.h @@ -86,7 +86,7 @@ class PairAmoeba : public Pair { double time_init,time_hal,time_repulse,time_disp; double time_mpole,time_induce,time_polar,time_qxfer; - + // energy/virial components double ehal,erepulse,edisp,epolar,empole,eqxfer; @@ -116,7 +116,7 @@ class PairAmoeba : public Pair { double special_polar_wscale[5]; double polar_dscale,polar_uscale; - + // scalar values defined in keyfile double dhal,ghal; @@ -132,7 +132,7 @@ class PairAmoeba : public Pair { double usolvcut; int use_ewald,use_dewald; - + int use_pred; int politer,polpred; int pcgprec,pcgguess; @@ -144,7 +144,7 @@ class PairAmoeba : public Pair { int aeewald_key,apewald_key,adewald_key; int pmegrid_key,dpmegrid_key; - + // types and classes int n_amtype; // # of defined AMOEBA types, 1-N @@ -155,7 +155,7 @@ class PairAmoeba : public Pair { int *amtype_defined; // 1 if type was defined in FF file int *amclass_defined; // 1 if class was defined in FF file int *amtype2class; // amt2c[i] = class which type I belongs to - + // static per-atom properties, must persist as atoms migrate int index_amtype,index_amgroup,index_ired; @@ -168,7 +168,7 @@ class PairAmoeba : public Pair { tagint *xaxis,*yaxis,*zaxis; // IDs of nearby atoms for multipole def int *polaxe; double *pval; - + char *id_pole,*id_udalt,*id_upalt; class FixStore *fixpole; // stores pole = multipole components class FixStore *fixudalt; // stores udalt = induced dipole history @@ -194,7 +194,7 @@ class PairAmoeba : public Pair { // multipole frame info for each amtype, read from PRM file int *nmultiframe; // # of frames for each type - int **mpaxis; // polaxe values + int **mpaxis; // polaxe values int **xpole,**ypole,**zpole; // other types in xyz dirs for multipole frame double ***fpole; // 13 values from file // 0 = monopole, same as q @@ -216,7 +216,7 @@ class PairAmoeba : public Pair { double *vdwl_sigma_pair; // Vdwl sigma for pair of classes int nvdwl_pair; // # of pairwise Vdwl entries in file int max_vdwl_pair; // size of allocated data for pairwise Vdwl - + // vectors and arrays of small size double *copt,*copm; // 0:optorder in length @@ -245,7 +245,7 @@ class PairAmoeba : public Pair { // peratom values computed each step // none of them persist with atoms // some of them need communication to ghosts - + double **rpole; // multipole, comm to ghosts int *xaxis2local,*yaxis2local,*zaxis2local; // xyz axis IDs -> local indices @@ -271,7 +271,7 @@ class PairAmoeba : public Pair { double ***fopt,***foptp; // computed in induce, used by polar, if OPT // Nlocal x optorder x 10 - + // derived local neighbor lists int *numneigh_dipole; // number of dipole neighs for each atom @@ -292,7 +292,7 @@ class PairAmoeba : public Pair { // in indices = owned portion of grid in spatial decomp // out indices = in + ghost grid cells // fft indices = owned portion of grid in FFT decomp - + int nefft1,nefft2,nefft3; // for electrostatic PME operations int ndfft1,ndfft2,ndfft3; // for dispersion PME operations @@ -300,12 +300,12 @@ class PairAmoeba : public Pair { int bsporder; // for polarization int bsdorder; // for dispersion int bsordermax; // max of 3 bsorder values - + double aewald; // current Ewald alpha double aeewald; // for electrostatics double apewald; // for polarization double adewald; // for dispersion - + double *bsmod1,*bsmod2,*bsmod3; // B-spline module along abc axes // set to max of any nfft1,nfft2,nfft3 @@ -318,12 +318,12 @@ class PairAmoeba : public Pair { // indices ARE flipped vs Fortran // Kspace data for induce and polar - + double *qfac; // convoulution pre-factors - double **cmp,**fmp,**cphi,**fphi; // Cartesian and fractional multipoles + double **cmp,**fmp,**cphi,**fphi; // Cartesian and fractional multipoles // params for current KSpace solve and FFT being worked on - + int nfft1,nfft2,nfft3; // size of FFT int bsorder; // stencil size double recip[3][3]; // indices NOT flipped vs Fortran @@ -332,12 +332,12 @@ class PairAmoeba : public Pair { class AmoebaConvolution *m_kspace,*p_kspace,*pc_kspace,*d_kspace; class AmoebaConvolution *i_kspace,*ic_kspace; - + // FFT grid size factors int nfactors; // # of factors int *factors; // list of possible factors (2,3,5) - + // components of force field void hal(); @@ -396,9 +396,9 @@ class PairAmoeba : public Pair { void kewald(); void kewald_parallel(int, int, int, int, - int &, int &, int &, int &, int &, int &, - int &, int &, int &, int &, int &, int &, - int &, int &, int &, int &, int &, int &); + int &, int &, int &, int &, int &, int &, + int &, int &, int &, int &, int &, int &, + int &, int &, int &, int &, int &, int &); double ewaldcof(double); int factorable(int); @@ -411,7 +411,7 @@ class PairAmoeba : public Pair { void allocate(); void print_settings(FILE *); - + void initialize_vdwl(); void allocate_vdwl(); void deallocate_vdwl(); @@ -447,7 +447,7 @@ class PairAmoeba : public Pair { void set_defaults(); void read_prmfile(char *); void read_keyfile(char *); - + int read_section_name(FILE *fp, char *); int read_section_line(FILE *fp, char *, int &, char *); int tokenize(char *, char **&, char *&); @@ -477,7 +477,7 @@ class PairAmoeba : public Pair { void file_charge_transfer(int, char **); // inline function for neighbor list unmasking - + inline int sbmask15(int j) const { return j >> SBBITS15 & 7; } diff --git a/src/angle.cpp b/src/angle.cpp index 15650be83f..d6e26d3ded 100644 --- a/src/angle.cpp +++ b/src/angle.cpp @@ -357,7 +357,7 @@ void Angle::ev_tally(int i, int j, int k, int nlocal, int newton_bond, double ea ------------------------------------------------------------------------- */ void Angle::ev_tally4(int i, int j, int k, int m, int nlocal, int newton_bond, - double eangle, + double eangle, double *f1, double *f2, double *f3, double *f4) { double eanglefourth,v[6]; diff --git a/src/atom.cpp b/src/atom.cpp index 15e002ad24..3d422ff086 100644 --- a/src/atom.cpp +++ b/src/atom.cpp @@ -215,7 +215,7 @@ Atom::Atom(LAMMPS *lmp) : Pointers(lmp) maxspecial15 = 1; nspecial15 = nullptr; special15 = nullptr; - + // DIELECTRIC package area = ed = em = epsilon = curvature = q_unscaled = nullptr; @@ -679,7 +679,7 @@ void Atom::set_atomflag_defaults() contact_radius_flag = smd_data_9_flag = smd_stress_flag = 0; eff_plastic_strain_flag = eff_plastic_strain_rate_flag = 0; nspecial15_flag = 0; - + pdscale = 1.0; } diff --git a/src/atom.h b/src/atom.h index 7643fb29f2..9e915b7d4f 100644 --- a/src/atom.h +++ b/src/atom.h @@ -208,7 +208,7 @@ class Atom : protected Pointers { // AMOEBA package int nspecial15_flag; - + // Peridynamics scale factor, used by dump cfg double pdscale; diff --git a/src/fix_property_atom.cpp b/src/fix_property_atom.cpp index 77aec9fe87..3e09815dfe 100644 --- a/src/fix_property_atom.cpp +++ b/src/fix_property_atom.cpp @@ -304,7 +304,7 @@ void FixPropertyAtom::read_data_section(char *keyword, int n, char *buf, tagint atom->iarray[index[j]][m][k] = values.next_int(); } else if (styles[j] == DARRAY) { ncol = cols[j]; - for (k = 0; k < ncol; k++) + for (k = 0; k < ncol; k++) atom->darray[index[j]][m][k] = values.next_double(); } } @@ -570,7 +570,7 @@ void FixPropertyAtom::copy_arrays(int i, int j, int /*delflag*/) atom->iarray[index[nv]][j][k] = atom->iarray[index[nv]][i][k]; } else if (styles[nv] == DARRAY) { ncol = cols[nv]; - for (k = 0; k < ncol; k++) + for (k = 0; k < ncol; k++) atom->darray[index[nv]][j][k] = atom->darray[index[nv]][i][k]; } } @@ -776,11 +776,11 @@ int FixPropertyAtom::pack_restart(int i, double *buf) buf[m++] = atom->dvector[index[nv]][i]; else if (styles[nv] == IARRAY) { ncol = cols[nv]; - for (k = 0; k < ncol; k++) + for (k = 0; k < ncol; k++) buf[m++] = ubuf(atom->iarray[index[nv]][i][k]).d; } else if (styles[nv] == DARRAY) { ncol = cols[nv]; - for (k = 0; k < ncol; k++) + for (k = 0; k < ncol; k++) buf[m++] = atom->darray[index[nv]][i][k]; } } diff --git a/src/fix_store.cpp b/src/fix_store.cpp index 4e2e8f46cb..9240270b02 100644 --- a/src/fix_store.cpp +++ b/src/fix_store.cpp @@ -105,7 +105,7 @@ vstore(nullptr), astore(nullptr), rbuf(nullptr) if (flavor == GLOBAL) { if (vecflag) { - for (int i = 0; i < n1; i++) + for (int i = 0; i < n1; i++) vstore[i] = 0.0; } else if (arrayflag) { for (int i = 0; i < n1; i++) @@ -117,7 +117,7 @@ vstore(nullptr), astore(nullptr), rbuf(nullptr) if (flavor == PERATOM) { int nlocal = atom->nlocal; if (vecflag) { - for (int i = 0; i < nlocal; i++) + for (int i = 0; i < nlocal; i++) vstore[i] = 0.0; } else if (arrayflag) { for (int i = 0; i < nlocal; i++) diff --git a/src/force.cpp b/src/force.cpp index 8b4e6fa9fb..2cb44f0d35 100644 --- a/src/force.cpp +++ b/src/force.cpp @@ -55,7 +55,7 @@ Force::Force(LAMMPS *lmp) : Pointers(lmp) special_angle = special_dihedral = 0; special_onefive = 0; special_extra = 0; - + dielectric = 1.0; qqr2e_lammps_real = 332.06371; // these constants are toggled qqr2e_charmm_real = 332.0716; // by new CHARMM pair styles @@ -706,7 +706,7 @@ void Force::set_special(int narg, char **arg) special_coul[1] = special_coul[2] = special_coul[3] = 0.0; special_angle = special_dihedral = 0; special_onefive = 0; - + int iarg = 0; while (iarg < narg) { if (strcmp(arg[iarg], "amber") == 0) { @@ -777,8 +777,8 @@ void Force::set_special(int narg, char **arg) else if (strcmp(arg[iarg+1],"yes") == 0) special_onefive = 1; else error->all(FLERR,"Illegal special_bonds command"); if (special_onefive && atom->nspecial15_flag == 0) - error->all(FLERR,"Cannot set special_bonds one/five if " - "atom style does not support it"); + error->all(FLERR,"Cannot set special_bonds one/five if " + "atom style does not support it"); iarg += 2; } else error->all(FLERR,"Illegal special_bonds command"); } diff --git a/src/force.h b/src/force.h index d5de8faf21..4c3e39bb5b 100644 --- a/src/force.h +++ b/src/force.h @@ -116,7 +116,7 @@ class Force : protected Pointers { // 1 if only weight 1,4 atoms if in a dihedral int special_extra; // extra space for added bonds int special_onefive; // 0 if 1-5 neighbors are not stored, 1 if yes - + Force(class LAMMPS *); ~Force() override; void init(); diff --git a/src/memory.h b/src/memory.h index 72ffbddaf4..ba6561825c 100644 --- a/src/memory.h +++ b/src/memory.h @@ -649,8 +649,8 @@ class Memory : protected Pointers { template TYPE ****create4d_offset_last(TYPE ****&array, int n1lo, int n1hi, - int n2lo, int n2hi, int n3lo, int n3hi, int n4, - const char *name) + int n2lo, int n2hi, int n3lo, int n3hi, int n4, + const char *name) { if (n1lo > n1hi || n2lo > n2hi || n3lo > n3hi || n4 <= 0) return nullptr; @@ -668,9 +668,9 @@ class Memory : protected Pointers { template TYPE ****create4d_offset_last(TYPE *****& /*array*/, int /*n1lo*/, int /*n1hi*/, - int /*n2lo*/, int /*n2hi*/, - int /*n3lo*/, int /*n3hi*/, int /*n4*/, - const char *name) + int /*n2lo*/, int /*n2hi*/, + int /*n3lo*/, int /*n3hi*/, int /*n4*/, + const char *name) {fail(name); return nullptr;} /* ---------------------------------------------------------------------- @@ -679,7 +679,7 @@ class Memory : protected Pointers { template void destroy4d_offset_last(TYPE ****&array, - int n1_offset, int n2_offset, int n3_offset) + int n1_offset, int n2_offset, int n3_offset) { if (array == nullptr) return; sfree(&array[n1_offset][n2_offset][n3_offset][0]); @@ -688,7 +688,7 @@ class Memory : protected Pointers { sfree(&array[n1_offset]); array = nullptr; } - + /* ---------------------------------------------------------------------- create a 5d array ------------------------------------------------------------------------- */ diff --git a/src/modify.cpp b/src/modify.cpp index 0286e62c96..9dda7b54f5 100644 --- a/src/modify.cpp +++ b/src/modify.cpp @@ -783,7 +783,7 @@ Fix *Modify::add_fix(int narg, char **arg, int trysuffix) const char *exceptions[] = {"GPU", "OMP", "INTEL", "property/atom", "cmap", "cmap3", "rx", - "deprecated", "STORE/KIM", "amoeba/pitorsion", "amoeba/bitorsion", + "deprecated", "STORE/KIM", "amoeba/pitorsion", "amoeba/bitorsion", nullptr}; if (domain->box_exist == 0) { diff --git a/src/pair.h b/src/pair.h index a7f052b66c..8c1c8340eb 100644 --- a/src/pair.h +++ b/src/pair.h @@ -192,12 +192,12 @@ class Pair : protected Pointers { virtual void unpack_forward_comm(int, int, double *) {} virtual int pack_reverse_comm(int, int, double *) { return 0; } virtual void unpack_reverse_comm(int, int *, double *) {} - + virtual void pack_forward_grid(int, void *, int, int *) {} virtual void unpack_forward_grid(int, void *, int, int *) {} virtual void pack_reverse_grid(int, void *, int, int *) {} virtual void unpack_reverse_grid(int, void *, int, int *) {} - + virtual double memory_usage(); void set_copymode(int value) { copymode = value; } diff --git a/src/special.cpp b/src/special.cpp index d2b06ce229..4882b5752b 100644 --- a/src/special.cpp +++ b/src/special.cpp @@ -73,7 +73,7 @@ void Special::build() // set onefive_flag if special_bonds command set it onefive_flag = force->special_onefive; - + // initialize nspecial counters to 0 int **nspecial = atom->nspecial; @@ -89,7 +89,7 @@ void Special::build() if (onefive_flag) { for (int i = 0; i < nlocal; i++) nspecial15[i] = 0; } - + // setup atomIDs and procowner vectors in rendezvous decomposition atom_owners(); @@ -107,7 +107,7 @@ void Special::build() // done if special_bond weights for 1-3, 1-4 are set to 1.0 // onefive_flag must also be off, else 1-4 is needed to create 1-5 - + if (!onefive_flag && force->special_lj[2] == 1.0 && force->special_coul[2] == 1.0 && force->special_lj[3] == 1.0 && force->special_coul[3] == 1.0) { @@ -132,7 +132,7 @@ void Special::build() // done if special_bond weights for 1-4 are set to 1.0 // onefive_flag must also be off, else 1-4 is needed to create 1-5 - + if (!onefive_flag && force->special_lj[3] == 1.0 && force->special_coul[3] == 1.0) { dedup(); @@ -671,7 +671,7 @@ void Special::dedup() int unique; // dedup onetwo - + for (i = 0; i < nlocal; i++) { unique = 0; atom->map_one(tag[i],0); @@ -703,7 +703,7 @@ void Special::dedup() atom->map_one(tag[i],-1); for (j = 0; j < unique; j++) atom->map_one(onethree[i][j],-1); } - + // dedup onefour for (i = 0; i < nlocal; i++) { @@ -728,11 +728,11 @@ void Special::dedup() unique = 0; atom->map_one(tag[i],0); for (j = 0; j < nspecial15[i]; j++) { - m = onefive[i][j]; - if (atom->map(m) < 0) { - onefive[i][unique++] = m; - atom->map_one(m,0); - } + m = onefive[i][j]; + if (atom->map(m) < 0) { + onefive[i][unique++] = m; + atom->map_one(m,0); + } } nspecial15[i] = unique; atom->map_one(tag[i],-1); @@ -784,7 +784,7 @@ void Special::combine() int unique,unique15; int maxspecial = 0; int maxspecial15 = 0; - + for (i = 0; i < nlocal; i++) { unique = 0; atom->map_one(tag[i],0); @@ -816,11 +816,11 @@ void Special::combine() if (onefive_flag) { unique15 = 0; for (j = 0; j < nspecial15[i]; j++) { - m = onefive[i][j]; - if (atom->map(m) < 0) { - unique15++; - atom->map_one(m,0); - } + m = onefive[i][j]; + if (atom->map(m) < 0) { + unique15++; + atom->map_one(m,0); + } } maxspecial15 = MAX(maxspecial15,unique15); } @@ -927,11 +927,11 @@ void Special::combine() if (onefive_flag) { unique15 = 0; for (j = 0; j < nspecial15[i]; j++) { - m = onefive[i][j]; - if (atom->map(m) < 0) { - special15[i][unique15++] = m; - atom->map_one(m,0); - } + m = onefive[i][j]; + if (atom->map(m) < 0) { + special15[i][unique15++] = m; + atom->map_one(m,0); + } } nspecial15[i] = unique15; } From df74043d0390583b3df9312e03c3f21938c5fdbc Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 18 Apr 2022 21:23:11 -0400 Subject: [PATCH 127/585] correct homepage URL --- src/AMOEBA/amoeba_charge_transfer.cpp | 2 +- src/AMOEBA/amoeba_convolution.cpp | 2 +- src/AMOEBA/amoeba_convolution.h | 2 +- src/AMOEBA/amoeba_dispersion.cpp | 2 +- src/AMOEBA/amoeba_file.cpp | 2 +- src/AMOEBA/amoeba_hal.cpp | 2 +- src/AMOEBA/amoeba_induce.cpp | 4 ++-- src/AMOEBA/amoeba_kspace.cpp | 2 +- src/AMOEBA/amoeba_multipole.cpp | 2 +- src/AMOEBA/amoeba_polar.cpp | 2 +- src/AMOEBA/amoeba_repulsion.cpp | 2 +- src/AMOEBA/amoeba_utils.cpp | 2 +- src/AMOEBA/atom_vec_amoeba.cpp | 2 +- src/AMOEBA/atom_vec_amoeba.h | 2 +- src/AMOEBA/pair_amoeba.cpp | 2 +- src/AMOEBA/pair_amoeba.h | 2 +- src/AMOEBA/pair_hippo.cpp | 2 +- src/AMOEBA/pair_hippo.h | 2 +- 18 files changed, 19 insertions(+), 19 deletions(-) diff --git a/src/AMOEBA/amoeba_charge_transfer.cpp b/src/AMOEBA/amoeba_charge_transfer.cpp index 3896c363bc..1d395e9924 100644 --- a/src/AMOEBA/amoeba_charge_transfer.cpp +++ b/src/AMOEBA/amoeba_charge_transfer.cpp @@ -1,6 +1,6 @@ /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator - http://lammps.sandia.gov, Sandia National Laboratories + https://www.lammps.org/ Sandia National Laboratories Steve Plimpton, sjplimp@sandia.gov Copyright (2003) Sandia Corporation. Under the terms of Contract diff --git a/src/AMOEBA/amoeba_convolution.cpp b/src/AMOEBA/amoeba_convolution.cpp index fe97fd6144..4759a047df 100644 --- a/src/AMOEBA/amoeba_convolution.cpp +++ b/src/AMOEBA/amoeba_convolution.cpp @@ -1,6 +1,6 @@ /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator - http://lammps.sandia.gov, Sandia National Laboratories + https://www.lammps.org/ Sandia National Laboratories Steve Plimpton, sjplimp@sandia.gov Copyright (2003) Sandia Corporation. Under the terms of Contract diff --git a/src/AMOEBA/amoeba_convolution.h b/src/AMOEBA/amoeba_convolution.h index 94502d3691..d15fe8d198 100644 --- a/src/AMOEBA/amoeba_convolution.h +++ b/src/AMOEBA/amoeba_convolution.h @@ -1,6 +1,6 @@ /* -*- c++ -*- ---------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator - http://lammps.sandia.gov, Sandia National Laboratories + https://www.lammps.org/ Sandia National Laboratories Steve Plimpton, sjplimp@sandia.gov Copyright (2003) Sandia Corporation. Under the terms of Contract diff --git a/src/AMOEBA/amoeba_dispersion.cpp b/src/AMOEBA/amoeba_dispersion.cpp index ffd57c4044..a3cd114ae4 100644 --- a/src/AMOEBA/amoeba_dispersion.cpp +++ b/src/AMOEBA/amoeba_dispersion.cpp @@ -1,6 +1,6 @@ /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator - http://lammps.sandia.gov, Sandia National Laboratories + https://www.lammps.org/ Sandia National Laboratories Steve Plimpton, sjplimp@sandia.gov Copyright (2003) Sandia Corporation. Under the terms of Contract diff --git a/src/AMOEBA/amoeba_file.cpp b/src/AMOEBA/amoeba_file.cpp index e1d57e165d..34fe2f87a9 100644 --- a/src/AMOEBA/amoeba_file.cpp +++ b/src/AMOEBA/amoeba_file.cpp @@ -1,6 +1,6 @@ /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel ator - http://lammps.sandia.gov, Sandia National Laboratories + https://www.lammps.org/ Sandia National Laboratories Steve Plimpton, sjplimp@sandia.gov Copyright (2003) Sandia Corporation. Under the terms of Contract diff --git a/src/AMOEBA/amoeba_hal.cpp b/src/AMOEBA/amoeba_hal.cpp index 6e69baa11c..f402221520 100644 --- a/src/AMOEBA/amoeba_hal.cpp +++ b/src/AMOEBA/amoeba_hal.cpp @@ -1,6 +1,6 @@ /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator - http://lammps.sandia.gov, Sandia National Laboratories + https://www.lammps.org/ Sandia National Laboratories Steve Plimpton, sjplimp@sandia.gov Copyright (2003) Sandia Corporation. Under the terms of Contract diff --git a/src/AMOEBA/amoeba_induce.cpp b/src/AMOEBA/amoeba_induce.cpp index 65a2a8a55c..beac1186f7 100644 --- a/src/AMOEBA/amoeba_induce.cpp +++ b/src/AMOEBA/amoeba_induce.cpp @@ -1,6 +1,6 @@ /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator - http://lammps.sandia.gov, Sandia National Laboratories + https://www.lammps.org/ Sandia National Laboratories Steve Plimpton, sjplimp@sandia.gov Copyright (2003) Sandia Corporation. Under the terms of Contract @@ -1377,7 +1377,7 @@ void PairAmoeba::udirect1(double **field) fphi_mpole(gridpost,fphi); // printf ("fphi %g %g %g %g %g %g %g %g %g %g %g %g\n", - // fphi[1][1],fphi[1][2],fphi[1][3],fphi[1][4],fphi[1][5], + // fphi[1][1],fphi[1][2],fphi[1][3],fphi[1][4],fphi[1][5], // fphi[1][6],fphi[1][7],fphi[1][8],fphi[1][9],fphi[1][10], // fphi[1][11],fphi[1][12]); diff --git a/src/AMOEBA/amoeba_kspace.cpp b/src/AMOEBA/amoeba_kspace.cpp index 094afd4241..00ec415c4c 100644 --- a/src/AMOEBA/amoeba_kspace.cpp +++ b/src/AMOEBA/amoeba_kspace.cpp @@ -1,6 +1,6 @@ /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator - http://lammps.sandia.gov, Sandia National Laboratories + https://www.lammps.org/ Sandia National Laboratories Steve Plimpton, sjplimp@sandia.gov Copyright (2003) Sandia Corporation. Under the terms of Contract diff --git a/src/AMOEBA/amoeba_multipole.cpp b/src/AMOEBA/amoeba_multipole.cpp index 66fe18ead2..d0a59a7a0b 100644 --- a/src/AMOEBA/amoeba_multipole.cpp +++ b/src/AMOEBA/amoeba_multipole.cpp @@ -1,6 +1,6 @@ /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator - http://lammps.sandia.gov, Sandia National Laboratories + https://www.lammps.org/ Sandia National Laboratories Steve Plimpton, sjplimp@sandia.gov Copyright (2003) Sandia Corporation. Under the terms of Contract diff --git a/src/AMOEBA/amoeba_polar.cpp b/src/AMOEBA/amoeba_polar.cpp index 55cafd32f6..0e9b5250f3 100644 --- a/src/AMOEBA/amoeba_polar.cpp +++ b/src/AMOEBA/amoeba_polar.cpp @@ -1,6 +1,6 @@ /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator - http://lammps.sandia.gov, Sandia National Laboratories + https://www.lammps.org/ Sandia National Laboratories Steve Plimpton, sjplimp@sandia.gov Copyright (2003) Sandia Corporation. Under the terms of Contract diff --git a/src/AMOEBA/amoeba_repulsion.cpp b/src/AMOEBA/amoeba_repulsion.cpp index 96e7b31312..a0694aeef4 100644 --- a/src/AMOEBA/amoeba_repulsion.cpp +++ b/src/AMOEBA/amoeba_repulsion.cpp @@ -1,6 +1,6 @@ /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator - http://lammps.sandia.gov, Sandia National Laboratories + https://www.lammps.org/ Sandia National Laboratories Steve Plimpton, sjplimp@sandia.gov Copyright (2003) Sandia Corporation. Under the terms of Contract diff --git a/src/AMOEBA/amoeba_utils.cpp b/src/AMOEBA/amoeba_utils.cpp index 1b9ce9e8ce..3a84d860b2 100644 --- a/src/AMOEBA/amoeba_utils.cpp +++ b/src/AMOEBA/amoeba_utils.cpp @@ -1,6 +1,6 @@ /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator - http://lammps.sandia.gov, Sandia National Laboratories + https://www.lammps.org/ Sandia National Laboratories Steve Plimpton, sjplimp@sandia.gov Copyright (2003) Sandia Corporation. Under the terms of Contract diff --git a/src/AMOEBA/atom_vec_amoeba.cpp b/src/AMOEBA/atom_vec_amoeba.cpp index 38c1629d32..6c782a382b 100644 --- a/src/AMOEBA/atom_vec_amoeba.cpp +++ b/src/AMOEBA/atom_vec_amoeba.cpp @@ -1,6 +1,6 @@ /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator - http://lammps.sandia.gov, Sandia National Laboratories + https://www.lammps.org/ Sandia National Laboratories Steve Plimpton, sjplimp@sandia.gov Copyright (2003) Sandia Corporation. Under the terms of Contract diff --git a/src/AMOEBA/atom_vec_amoeba.h b/src/AMOEBA/atom_vec_amoeba.h index 9f0c075668..8953023550 100644 --- a/src/AMOEBA/atom_vec_amoeba.h +++ b/src/AMOEBA/atom_vec_amoeba.h @@ -1,6 +1,6 @@ /* -*- c++ -*- ---------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator - http://lammps.sandia.gov, Sandia National Laboratories + https://www.lammps.org/ Sandia National Laboratories Steve Plimpton, sjplimp@sandia.gov Copyright (2003) Sandia Corporation. Under the terms of Contract diff --git a/src/AMOEBA/pair_amoeba.cpp b/src/AMOEBA/pair_amoeba.cpp index 2203c220ff..d158cc21d2 100644 --- a/src/AMOEBA/pair_amoeba.cpp +++ b/src/AMOEBA/pair_amoeba.cpp @@ -1,6 +1,6 @@ /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator - http://lammps.sandia.gov, Sandia National Laboratories + https://www.lammps.org/ Sandia National Laboratories Steve Plimpton, sjplimp@sandia.gov Copyright (2003) Sandia Corporation. Under the terms of Contract diff --git a/src/AMOEBA/pair_amoeba.h b/src/AMOEBA/pair_amoeba.h index 3595a5920b..15ba4d8526 100644 --- a/src/AMOEBA/pair_amoeba.h +++ b/src/AMOEBA/pair_amoeba.h @@ -1,6 +1,6 @@ /* -*- c++ -*- ---------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator - http://lammps.sandia.gov, Sandia National Laboratories + https://www.lammps.org/ Sandia National Laboratories Steve Plimpton, sjplimp@sandia.gov Copyright (2003) Sandia Corporation. Under the terms of Contract diff --git a/src/AMOEBA/pair_hippo.cpp b/src/AMOEBA/pair_hippo.cpp index b5af47aaaf..f64d419183 100644 --- a/src/AMOEBA/pair_hippo.cpp +++ b/src/AMOEBA/pair_hippo.cpp @@ -1,6 +1,6 @@ /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator - http://lammps.sandia.gov, Sandia National Laboratories + https://www.lammps.org/ Sandia National Laboratories Steve Plimpton, sjplimp@sandia.gov Copyright (2003) Sandia Corporation. Under the terms of Contract diff --git a/src/AMOEBA/pair_hippo.h b/src/AMOEBA/pair_hippo.h index da391576cb..f54c2516e5 100644 --- a/src/AMOEBA/pair_hippo.h +++ b/src/AMOEBA/pair_hippo.h @@ -1,6 +1,6 @@ /* -*- c++ -*- ---------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator - http://lammps.sandia.gov, Sandia National Laboratories + https://www.lammps.org/ Sandia National Laboratories Steve Plimpton, sjplimp@sandia.gov Copyright (2003) Sandia Corporation. Under the terms of Contract From a9ac398d2beb451890620b1440b3f951df60c54e Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 18 Apr 2022 22:08:05 -0400 Subject: [PATCH 128/585] correct for updated forward/reverse comm API --- src/AMOEBA/pair_amoeba.cpp | 53 +++++++++++++++++++------------------- 1 file changed, 27 insertions(+), 26 deletions(-) diff --git a/src/AMOEBA/pair_amoeba.cpp b/src/AMOEBA/pair_amoeba.cpp index d158cc21d2..a777b79486 100644 --- a/src/AMOEBA/pair_amoeba.cpp +++ b/src/AMOEBA/pair_amoeba.cpp @@ -12,29 +12,30 @@ ------------------------------------------------------------------------- */ #include "pair_amoeba.h" -#include + +#include "amoeba_convolution.h" +#include "atom.h" +#include "comm.h" +#include "domain.h" +#include "error.h" +#include "fft3d_wrap.h" +#include "fix.h" +#include "fix_store.h" +#include "force.h" +#include "gridcomm.h" +#include "group.h" +#include "memory.h" +#include "modify.h" +#include "my_page.h" +#include "neigh_list.h" +#include "neigh_request.h" +#include "neighbor.h" +#include "update.h" +#include "utils.h" + #include #include #include -#include "amoeba_convolution.h" -#include "atom.h" -#include "update.h" -#include "domain.h" -#include "force.h" -#include "comm.h" -#include "neighbor.h" -#include "neigh_request.h" -#include "neigh_list.h" -#include "group.h" -#include "modify.h" -#include "fix.h" -#include "fix_store.h" -#include "fft3d_wrap.h" -#include "gridcomm.h" -#include "my_page.h" -#include "memory.h" -#include "error.h" -#include "utils.h" using namespace LAMMPS_NS; @@ -284,7 +285,7 @@ void PairAmoeba::compute(int eflag, int vflag) if (first_flag_compute) { cfstyle = KMPOLE; - comm->forward_comm_pair(this); + comm->forward_comm(this); kmpole(); if (hippo) { @@ -298,7 +299,7 @@ void PairAmoeba::compute(int eflag, int vflag) pval[i] = pole[i][0] - pcore[iclass]; } cfstyle = PVAL; - comm->forward_comm_pair(this); + comm->forward_comm(this); } } @@ -364,7 +365,7 @@ void PairAmoeba::compute(int eflag, int vflag) if (amoeba) cfstyle = SETUP_AMOEBA; else cfstyle = SETUP_HIPPO; - comm->forward_comm_pair(this); + comm->forward_comm(this); if (amoeba) pbc_xred(); @@ -400,7 +401,7 @@ void PairAmoeba::compute(int eflag, int vflag) if (polar_rspace_flag || polar_kspace_flag) { induce(); cfstyle = INDUCE; - comm->forward_comm_pair(this); + comm->forward_comm(this); } time6 = MPI_Wtime(); @@ -1609,7 +1610,7 @@ void PairAmoeba::assign_groups() for (i = 0; i < nlocal; i++) amgroup[i] = tag[i]; cfstyle = AMGROUP; - comm->forward_comm_pair(this); + comm->forward_comm(this); // loop until no ghost atom groupIDs are reset @@ -1687,7 +1688,7 @@ void PairAmoeba::assign_groups() // communicate new groupIDs to ghost atoms cfstyle = AMGROUP; - comm->forward_comm_pair(this); + comm->forward_comm(this); // done if no proc reset groupID of a ghost atom From a73fc87f90c6f42875774f0a7f8ebf4e11da05cc Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 19 Apr 2022 04:35:25 -0400 Subject: [PATCH 129/585] add AMOEBA package to CMake build system --- cmake/CMakeLists.txt | 1 + cmake/presets/all_off.cmake | 1 + cmake/presets/all_on.cmake | 1 + cmake/presets/mingw-cross.cmake | 1 + cmake/presets/most.cmake | 1 + cmake/presets/windows.cmake | 1 + 6 files changed, 6 insertions(+) diff --git a/cmake/CMakeLists.txt b/cmake/CMakeLists.txt index 7d1b2894c8..0b57eae4f4 100644 --- a/cmake/CMakeLists.txt +++ b/cmake/CMakeLists.txt @@ -167,6 +167,7 @@ option(CMAKE_VERBOSE_MAKEFILE "Generate verbose Makefiles" OFF) set(STANDARD_PACKAGES ADIOS + AMOEBA ASPHERE ATC AWPMD diff --git a/cmake/presets/all_off.cmake b/cmake/presets/all_off.cmake index 6a8f70c9ea..fff167fa0b 100644 --- a/cmake/presets/all_off.cmake +++ b/cmake/presets/all_off.cmake @@ -3,6 +3,7 @@ set(ALL_PACKAGES ADIOS + AMOEBA ASPHERE ATC AWPMD diff --git a/cmake/presets/all_on.cmake b/cmake/presets/all_on.cmake index 4cff7d945d..df42c09232 100644 --- a/cmake/presets/all_on.cmake +++ b/cmake/presets/all_on.cmake @@ -5,6 +5,7 @@ set(ALL_PACKAGES ADIOS + AMOEBA ASPHERE ATC AWPMD diff --git a/cmake/presets/mingw-cross.cmake b/cmake/presets/mingw-cross.cmake index ef7f15fec2..1e78537686 100644 --- a/cmake/presets/mingw-cross.cmake +++ b/cmake/presets/mingw-cross.cmake @@ -1,4 +1,5 @@ set(WIN_PACKAGES + AMOEBA ASPHERE ATC AWPMD diff --git a/cmake/presets/most.cmake b/cmake/presets/most.cmake index 44d668fd83..481193a627 100644 --- a/cmake/presets/most.cmake +++ b/cmake/presets/most.cmake @@ -3,6 +3,7 @@ # are removed. The resulting binary should be able to run most inputs. set(ALL_PACKAGES + AMOEBA ASPHERE BOCS BODY diff --git a/cmake/presets/windows.cmake b/cmake/presets/windows.cmake index c83b16d855..cb75d8aac0 100644 --- a/cmake/presets/windows.cmake +++ b/cmake/presets/windows.cmake @@ -1,4 +1,5 @@ set(WIN_PACKAGES + AMOEBA ASPHERE BOCS BODY From f335b9afc0e8042b7129283cadf4ee5b9d9032be Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 19 Apr 2022 04:38:41 -0400 Subject: [PATCH 130/585] add AMOEBA package to "most" preset in GNU build --- src/Makefile | 1 + 1 file changed, 1 insertion(+) diff --git a/src/Makefile b/src/Makefile index 86adb86ac7..fd42cb9ebb 100644 --- a/src/Makefile +++ b/src/Makefile @@ -146,6 +146,7 @@ PACKAGE = \ PACKBASIC = kspace manybody molecule rigid PACKMOST = \ + amoeba \ asphere \ bocs \ body \ From c015851fbfcaf9b7da757cdbe8101a7d3f19fb8b Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 19 Apr 2022 07:39:07 -0400 Subject: [PATCH 131/585] fix 64-bit bug --- src/AMOEBA/amoeba_utils.cpp | 4 ++-- src/AMOEBA/pair_amoeba.cpp | 8 ++++---- 2 files changed, 6 insertions(+), 6 deletions(-) diff --git a/src/AMOEBA/amoeba_utils.cpp b/src/AMOEBA/amoeba_utils.cpp index 3a84d860b2..e7eb99cced 100644 --- a/src/AMOEBA/amoeba_utils.cpp +++ b/src/AMOEBA/amoeba_utils.cpp @@ -59,7 +59,7 @@ void PairAmoeba::kmpole() double **pole = fixpole->astore; int **nspecial = atom->nspecial; - int **special = atom->special; + tagint **special = atom->special; int nlocal = atom->nlocal; int nmissing = 0; @@ -639,7 +639,7 @@ void PairAmoeba::add_onefive_neighbors() tagint *tag = atom->tag; int *nspecial15 = atom->nspecial15; - int **special15 = atom->special15; + tagint **special15 = atom->special15; for (ii = 0; ii < inum; ii++) { i = ilist[ii]; diff --git a/src/AMOEBA/pair_amoeba.cpp b/src/AMOEBA/pair_amoeba.cpp index a777b79486..17ea496480 100644 --- a/src/AMOEBA/pair_amoeba.cpp +++ b/src/AMOEBA/pair_amoeba.cpp @@ -928,7 +928,7 @@ void PairAmoeba::init_style() ired = atom->ivector[index_ired]; int **nspecial = atom->nspecial; - int **special = atom->special; + tagint **special = atom->special; int nlocal = atom->nlocal; int itype,iclass; @@ -1192,7 +1192,7 @@ int PairAmoeba::pack_forward_comm(int n, int *list, double *buf, } else if (cfstyle == KMPOLE) { int **nspecial = atom->nspecial; - int **special = atom->special; + tagint **special = atom->special; for (i = 0; i < n; i++) { j = list[i]; buf[m++] = ubuf(nspecial[j][0]).d; @@ -1297,7 +1297,7 @@ void PairAmoeba::unpack_forward_comm(int n, int first, double *buf) } else if (cfstyle == KMPOLE) { int **nspecial = atom->nspecial; - int **special = atom->special; + tagint **special = atom->special; for (i = first; i < last; i++) { nspecial[i][0] = (int) ubuf(buf[m++]).i; for (k = 0; k < nspecial[i][0]; k++) @@ -1599,7 +1599,7 @@ void PairAmoeba::assign_groups() int maxstack = 0; int *stack = NULL; - int **special = atom->special; + tagint **special = atom->special; int **nspecial = atom->nspecial; tagint *tag = atom->tag; int nlocal = atom->nlocal; From bae7fd74b095d6fc1b14ad13b4aee3994684a692 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Tue, 19 Apr 2022 09:09:31 -0600 Subject: [PATCH 132/585] doc page tweaks --- doc/src/Howto_amoeba.rst | 108 +++++++++++++++---------------- doc/src/angle_amoeba.rst | 19 +++--- doc/src/fix_amoeba_bitorsion.rst | 19 +++--- doc/src/fix_amoeba_pitorsion.rst | 34 ++++------ doc/src/improper_amoeba.rst | 12 ++-- doc/src/pair_amoeba.rst | 17 +++-- 6 files changed, 100 insertions(+), 109 deletions(-) diff --git a/doc/src/Howto_amoeba.rst b/doc/src/Howto_amoeba.rst index 6615e319a6..404055fac0 100644 --- a/doc/src/Howto_amoeba.rst +++ b/doc/src/Howto_amoeba.rst @@ -36,7 +36,7 @@ details for HIPPO are in this paper: :ref:`(Rackers) U & = U_{intermolecular} + U_{intramolecular) \\ U_{intermolecular} & = U_{hal} + U_{repulsion} + U_{dispersion} + U_{multipole} + U_{polar} + U_{qxfer} \\ - U_{intramolecular} & = U_{bond} + U_{angle} + U_{torsion} + U_{oop} + U_{b\theta} + U_{Urey-Bradley} + U_{pitorsion} + U_{bitorsion} + U_{intramolecular} & = U_{bond} + U_{angle} + U_{torsion} + U_{oop} + U_{b\theta} + U_{UB} + U_{pitorsion} + U_{bitorsion} For intermolecular terms, the AMOEBA force field includes only the :math:`U_{hal}`, :math:`U_{multipole}`, :math:`U_{polar}` terms. The @@ -50,9 +50,9 @@ For intramolecular terms, the :math:`U_{bond}`, :math:`U_{angle}`, `, :doc:`dihedral_style fourier `, and :doc:`improper_style amoeba ` commands respectively. The :doc:`angle_style amoeba ` command includes the -:math:`U_{b\theta}` bond-angle cross term, and the -:math:`U_{Urey-Bradley}` term for a bond contribution between the 1-3 -atoms in the angle. +:math:`U_{b\theta}` bond-angle cross term, and the :math:`U_{UB}` term +for a Urey-Bradley bond contribution between the I,K atoms in the IJK +angle. The :math:`U_{pitorsion}` term is computed by the :doc:`fix amoeba/pitorsion ` command. It computes 6-body @@ -121,15 +121,15 @@ The data file read by the :doc:`read_data ` command should be created by the tools/tinker/tinker2lmp.py conversion program described below. It will create a section in the data file with the header "Tinker Types". A :doc:`fix property/atom ` -command for the data must be specified befroe the read_data command. -In the example above the fix ID is amtype. +command for the data must be specified before the read_data command. +In the example above the fix ID is *amtype*. Similarly, if the system you are simulating defines AMOEBA/HIPPO pitorsion or bitorsion interactions, there will be entries in the data file for those interactions. They require a :doc:`fix amoeba/pitortion ` and :doc:`fix amoeba/bitorsion ` command be defined. In the -example above, the IDs for these two fixes are "pit" and "bit". +example above, the IDs for these two fixes are *pit* and *bit*. Of course, if the system being modeled does not have one or more of the following -- bond, angle, dihedral, improper, pitorision, @@ -139,8 +139,9 @@ examples/amoeba for water systems as examples; they are simpler than what is listed above. The two :doc:`fix property/atom ` commands with IDs -"extra" and "polaxe" are also needed to define internal per-atom -quantities used by the AMOEBA and HIPPO force fields. +(in the example above) *extra* and *polaxe* are also needed to define +internal per-atom quantities used by the AMOEBA and HIPPO force +fields. The :doc:`pair_coeff ` command used for either the AMOEBA or HIPPO force field takes two arguments for Tinker force field files, @@ -150,7 +151,7 @@ files are meant to allow use of native Tinker files as-is. However LAMMPS does not support all the options which can be included in a Tinker PRM or KEY file. See specifis below. -A :doc:`special_bonds ` command with the "one/five" +A :doc:`special_bonds ` command with the *one/five* option is required, since the AMOEBA/HIPPO force fields define weighting factors for not only 1-2, 1-3, 1-4 interactions, but also 1-5 interactions. This command will trigger a per-atom list of 1-5 @@ -171,7 +172,7 @@ details: Tinker PRM and KEY files A Tinker PRM file is composed of sections, each of which has multiple -lines. This is the list of sections LAMMPS knows how to parse and +lines. This is the list of PRM sections LAMMPS knows how to parse and use. Any other sections are skipped: * Angle Bending Parameters @@ -194,60 +195,59 @@ use. Any other sections are skipped: * Van der Waals Pair Parameters * Van der Waals Parameters -A Tinker KEY file is composed of lines, each of which has a keyword, -which can be followed by zero or more parameters. This is the list of -keywords LAMMPS knows how to parse and use in the same manner Tinker -does. Any other keywords are skipped. The value following the equal -sign is the default value for the keyword if it is not specified, or -if the keyfile in the :doc:`pair_coeff ` command is -specified as NULL: +A Tinker KEY file is composed of lines, each of which has a keyword +followed by zero or more parameters. This is the list of keywords +LAMMPS knows how to parse and use in the same manner Tinker does. Any +other keywords are skipped. The value in parenthesis is the default +value for the keyword if it is not specified, or if the keyfile in the +:doc:`pair_coeff ` command is specified as NULL: -* a-axis = 0.0 -* b-axis = 0.0 -* c-axis = 0.0 -* ctrn-cutoff = 6.0 -* ctrn-taper = 0.9 * ctrn-cutoff +* a-axis (0.0) +* b-axis (0.0) +* c-axis (0.0) +* ctrn-cutoff (6.0) +* ctrn-taper (0.9 * ctrn-cutoff) * cutoff -* delta-halgren = 0.07 -* dewald = no use of long-range dispersion unless specified -* dewald-alpha = 0.4 -* dewald-cutoff = 7.0 -* dispersion-cutoff = 9.0 -* dispersion-taper = 9.0 * dispersion-cutoff +* delta-halgren (0.07) +* dewald (no long-range dispersion unless specified) +* dewald-alpha (0.4) +* dewald-cutoff (7.0) +* dispersion-cutoff (9.0) +* dispersion-taper (9.0 * dispersion-cutoff) * dpme-grid -* dpme-order = 4 -* ewald = no use of long-range electrostatics unless specified -* ewald-alpha = 0.4 -* ewald-cutoff = 7.0 -* gamma-halgren = 0.12 -* mpole-cutoff = 9.0 -* mpole-taper 0.65 * mpole-cutoff -* pcg-guess = enabled (default) -* pcg-noguess = disable pcg-guess -* pcg-noprecond = disable pcg-precond -* pcg-peek = 1.0 -* pcg-precond = enabled (default) -* pewald-alpha = 0.4 +* dpme-order (4) +* ewald (no long-range electrostatics unless specified) +* ewald-alpha (0.4) +* ewald-cutoff (7.0) +* gamma-halgren (0.12) +* mpole-cutoff (9.0) +* mpole-taper (0.65 * mpole-cutoff) +* pcg-guess (enabled by default) +* pcg-noguess (disable pcg-guess if specified) +* pcg-noprecond (disable pcg-precond if specified) +* pcg-peek (1.0) +* pcg-precond (enabled by default) +* pewald-alpha (0.4) * pme-grid -* pme-order = 5 -* polar-eps = 1.0e-6 -* polar-iter = 100 -* polar-predict = no prediction operation unless specified -* ppme-order = 5 -* repulsion-cutoff = 6.0 -* repulsion-taper = 0.9 * repulsion-cutoff +* pme-order (5) +* polar-eps (1.0e-6) +* polar-iter (100) +* polar-predict (no prediction operation unless specified) +* ppme-order (5) +* repulsion-cutoff (6.0) +* repulsion-taper (0.9 * repulsion-cutoff) * taper -* usolve-cutoff = 4.5 -* usolve-diag = 2.0 -* vdw-cutoff = 9.0 -* vdw-taper = 0.9 * vdw-cutoff +* usolve-cutoff (4.5) +* usolve-diag (2.0) +* vdw-cutoff (9.0) +* vdw-taper (0.9 * vdw-cutoff) ---------- Tinker2lmp.py tool This conversion tool is found in the tools/tinker directory. -As listed in examples/amoeba/README, these commands produce +As shown in examples/amoeba/README, these commands produce the data files found in examples/amoeba, and also illustrate all the options available to use with the tinker2lmp.py script: diff --git a/doc/src/angle_amoeba.rst b/doc/src/angle_amoeba.rst index 9a20299f45..8f4a45c8ec 100644 --- a/doc/src/angle_amoeba.rst +++ b/doc/src/angle_amoeba.rst @@ -31,23 +31,23 @@ The *amoeba* angle style uses the potential E & = E_a + E_{ba} + E_{ub} \\ E_a = K_2\left(\theta - \theta_0\right)^2 + K_3\left(\theta - \theta_0\right)^3 + K_4\left(\theta - \theta_0\right)^4 + K_5\left(\theta - \theta_0\right)^5 + K_6\left(\theta - \theta_0\right)^6 E_{ba} & = N_1 (r_{ij} - r_1) (\theta - \theta_0) + N_2(r_{jk} - r_2)(\theta - \theta_0) - E_{ub} & = K_{ub} (r_{ik} - r_{ub})^2) + E_{UB} & = K_{ub} (r_{ik} - r_{ub})^2) where :math:`E_a` is the angle term, :math:`E_{ba}` is a bond-angle -term, ::math:`E_{ub}` is a Urey-Bradley bond term, :math:`\theta_0` is +term, :math:`E_{UB}` is a Urey-Bradley bond term, :math:`\theta_0` is the equilibrium angle, :math:`r_1` and :math:`r_2` are the equilibrium bond lengths, and :math:`r_{ub}` is the equilibrium Urey-Bradley bond -length between atoms I and K in the angle IJK. +length. -These formulas match how the Tinker MD code does its angle +These formulas match how the Tinker MD code performs its angle calculations for the AMOEBA and HIPPO force fields. See the -doc:`Howto amoeba ` doc page for more information about +:doc:`Howto amoeba ` doc page for more information about the implemention of AMOEBA and HIPPO in LAMMPS. Note that the :math:`E_a` and :math:`E_{ba}` formulas are identical to those used for the :doc:`angle_style class2/p6 ` command, however there is no bond-bond cross term formula for -:math:`E_{bb}`. Additionally, there is a :math:`E_{ub}` term for a +:math:`E_{bb}`. Additionally, there is a :math:`E_{UB}` term for a Urey-Bradley bond. It is effectively a harmonic bond between the I and K atoms of angle IJK, even though that bond is not enumerated in the "Bonds" section of the data file. @@ -59,7 +59,7 @@ which Tinker may use if the center atom J in the angle is bonded to one additional atom in addition to I and K. In this case, all 4 atoms are used to compute the :math:`E_a` formula, resulting in forces on all 4 atoms. In the Tinker PRM file, these 2 options are denoted by -"angle" versus "anglep" entries in the "Angle Bending Parameters" +*angle* versus *anglep* entries in the "Angle Bending Parameters" section of the PRM force field file. The *pflag* coefficient described below selects between the 2 options. @@ -87,8 +87,9 @@ A pflag value of 0 vs 1 selects between the "in-plane" and "out-of-plane" options described above. Ubflag is 1 if there is a Urey-Bradley term associated with this angle type, else it is 0. :math:`\theta_0` is specified in degrees, but LAMMPS converts it to -radians internally; hence the various :math:`K` are effectively energy -per radian\^2 or radian\^3 or radian\^4 or radian\^5 or radian\^6. +radians internally; hence the various :math:`K` vaues are effectively +energy per radian\^2 or radian\^3 or radian\^4 or radian\^5 or +radian\^6. For the :math:`E_{ba}` formula, each line in a :doc:`angle_coeff ` command in the input script lists 5 coefficients, the diff --git a/doc/src/fix_amoeba_bitorsion.rst b/doc/src/fix_amoeba_bitorsion.rst index b05c2128d6..8f4c45dc8c 100644 --- a/doc/src/fix_amoeba_bitorsion.rst +++ b/doc/src/fix_amoeba_bitorsion.rst @@ -30,7 +30,7 @@ This command enables 5-body torsion/torsion interactions to be added to simulations which use the AMOEBA and HIPPO force fields. It matches how the Tinker MD code computes its torsion/torsion interactions for the AMOEBA and HIPPO force fields. See the -doc:`Howto amoeba ` doc page for more information about +:doc:`Howto amoeba ` doc page for more information about the implemention of AMOEBA and HIPPO in LAMMPS. Bitorsion interactions add additional potential energy contributions @@ -46,10 +46,10 @@ file that contains a listing of bitorsion interactions. The *filename* specified should contain the bitorsion parameters for the AMOEBA or HIPPO force field. -The data file read by the "read_data" must contain the topology of all -the bitorsion interactions, similar to the topology data for bonds, -angles, dihedrals, etc. Specially it should have a line like this in -its header section: +The data file read by the :doc:`read_data ` command must +contain the topology of all the bitorsion interactions, similar to the +topology data for bonds, angles, dihedrals, etc. Specifically it +should have a line like this in its header section: .. parsed-literal:: @@ -70,13 +70,12 @@ lines: The first column is an index from 1 to N to enumerate the bitorsion 5-atom tuples; it is ignored by LAMMPS. The second column is the -"type" of the interaction; it is an index into the bitorsion force +*type* of the interaction; it is an index into the bitorsion force field file. The remaining 5 columns are the atom IDs of the atoms in the two 4-atom dihedrals that overlap to create the bitorsion 5-body -interaction. Note that the "bitorsions" and "BiTorsions" keywords for -the header and body sections match those specified in the read_data -command following the data file name; see the :doc:`read_data -` page for more details. +interaction. Note that the *bitorsions* and *BiTorsions* keywords for +the header and body sections match those specified in the +:doc:`read_data ` command following the data file name. The data file should be generated by using the tools/tinker/tinker2lmp.py conversion script which creates a LAMMPS diff --git a/doc/src/fix_amoeba_pitorsion.rst b/doc/src/fix_amoeba_pitorsion.rst index b80ca3a285..762f5b8e53 100644 --- a/doc/src/fix_amoeba_pitorsion.rst +++ b/doc/src/fix_amoeba_pitorsion.rst @@ -29,7 +29,7 @@ Description This command enables 6-body pitorsion interactions to be added to simulations which use the AMOEBA and HIPPO force fields. It matches how the Tinker MD code computes its pitorsion interactions for the -AMOEBA and HIPPO force fields. See the doc:`Howto amoeba +AMOEBA and HIPPO force fields. See the :doc:`Howto amoeba ` doc page for more information about the implemention of AMOEBA and HIPPO in LAMMPS. @@ -43,14 +43,12 @@ for ubiquitin, which illustrates use of the fix amoeba/pitorsion command. As in the example above, this fix should be used before reading a data -file that contains a listing of pitorsion interactions. The -*filename* specified should contain the pitorsion parameters for the -AMOEBA or HIPPO force field. +file that contains a listing of pitorsion interactions. -The data file read by the "read_data" must contain the topology of all -the pitorsion interactions, similar to the topology data for bonds, -angles, dihedrals, etc. Specially it should have two lines like these -in its header section: +The data file read by the :doc:`read_data ` command must +contain the topology of all the pitorsion interactions, similar to the +topology data for bonds, angles, dihedrals, etc. Specifically it +should have two lines like these in its header section: .. parsed-literal:: @@ -59,7 +57,7 @@ in its header section: where N is the number of pitorsion 5-body interactions and M is the number of pitorsion types. It should also have two sections in the body -of the data file like these with M and N lines: +of the data file like these with M and N lines each: .. parsed-literal:: @@ -81,7 +79,7 @@ of the data file like these with M and N lines: For PiTorsion Coeffs, the first column is an index from 1 to M to enumerate the pitorsion types. The second column is the single -coefficient needed for each type. +prefactor coefficient needed for each type. For PiTorsions, the first column is an index from 1 to N to enumerate the pitorsion 5-atom tuples; it is ignored by LAMMPS. The second @@ -90,22 +88,16 @@ PiTorsion Coeffs. The remaining 5 columns are the atom IDs of the atoms in the two 4-atom dihedrals that overlap to create the pitorsion 5-body interaction. -Note that the "pitorsion types" and "pitorsions" and "PiTorsion -Coeffs" and "PiTorsions" keywords for the header and body sections -match those specified in the read_data command following the data file -name; see the :doc:`read_data ` page for more details. - -A data file containing pitorsion 6-body interactions can be generated -from using the tinker2lmp.py script in the tools/tinker directory of -the LAMMPS distribution. See the examples for its use for the -ubiquitin system in the tools/tinker/README file. +Note that the *pitorsion types* and *pitorsions* and *PiTorsion +Coeffs* and *PiTorsions* keywords for the header and body sections of +the data file match those specified in the :doc:`read_data +` command following the data file name. The data file should be generated by using the tools/tinker/tinker2lmp.py conversion script which creates a LAMMPS data file from Tinker input files, including its PRM file which contains the parameters necessary for computing pitorsion -interactions. See the example for the ubiquitin system in the -tools/tinker/README file. +interactions. The potential energy associated with pitorsion interactions can be output as described below. It can also be included in the total diff --git a/doc/src/improper_amoeba.rst b/doc/src/improper_amoeba.rst index 75f32abaf7..b5507235a2 100644 --- a/doc/src/improper_amoeba.rst +++ b/doc/src/improper_amoeba.rst @@ -35,15 +35,15 @@ This formula seems like a simplified version of the formula for the :math:`\chi_0` = 0.0. However the computation of the angle :math:`\chi` is done differently to match how the Tinker MD code computes its out-of-plane improper for the AMOEBA and HIPPO force -fields. See the doc:`Howto amoeba ` doc page for more +fields. See the :doc:`Howto amoeba ` doc page for more information about the implemention of AMOEBA and HIPPO in LAMMPS. If the 4 atoms in an improper quadruplet (listed in the data file read -by the :doc:`read_data ` command) are ordered I,J,K,L then -atoms I,K,L form a plane and atom J is out-of-place. The angle -:math:`\chi_0` is computed as the Allinger angle which is defined as -the angle between the plane of I,K,L, and the vector from atom I to -atom J. +by the :doc:`read_data ` command are ordered I,J,K,L then +atoms I,K,L are considered to lie in a plane and atom J is +out-of-place. The angle :math:`\chi_0` is computed as the Allinger +angle which is defined as the angle between the plane of I,K,L, and +the vector from atom I to atom J. The following coefficient must be defined for each improper type via the :doc:`improper_coeff ` command as in the example diff --git a/doc/src/pair_amoeba.rst b/doc/src/pair_amoeba.rst index c301caa332..3d11aa93ea 100644 --- a/doc/src/pair_amoeba.rst +++ b/doc/src/pair_amoeba.rst @@ -33,7 +33,7 @@ Examples Additional info """"""""""""""" -* doc:`Howto amoeba ` +* :doc:`Howto amoeba ` * examples/amoeba * tools/amoeba * potentials/*.amoeba @@ -57,7 +57,7 @@ the LAMMPS potentials directory with a "amoeba" or "hippo" suffix can be used. The Tinker distribution and website have additional force field files as well. -As discussed on the doc:`Howto amoeba ` doc page, the +As discussed on the :doc:`Howto amoeba ` doc page, the intermolecular (non-bonded) portion of the AMOEBA force field contains these terms: @@ -117,17 +117,17 @@ Examples of the PRM files are in the potentials directory with an *.amoeba or *.hippo suffix. The examples/amoeba directory has examples of both PRM and KEY files. -A Tinker PRM file composed of sections, each of which has multiple -lines. A Tinker KEY file is composed of lines, each of which has a keyword, -which can be followed by zero or more parameters. +A Tinker PRM file is composed of sections, each of which has multiple +lines. A Tinker KEY file is composed of lines, each of which has a +keyword, followed by zero or more parameters. The list of PRM sections and KEY keywords which LAMMPS recognizes are -listed on the doc:`Howto amoeba ` doc page. If not +listed on the :doc:`Howto amoeba ` doc page. If not recognized, the section or keyword is skipped. Note that if the KEY file is specified as NULL, then no file is required; default values for various AMOEBA/HIPPO settings are used. -The doc:`Howto amoeba ` doc page also gives the default +The :doc:`Howto amoeba ` doc page also gives the default settings. ---------- @@ -212,8 +212,7 @@ none .. _amoeba-Shi: -**(Shi)** Shi, Xiz, Znahg, Best, Wu, Ponder, Ren, J Chem Theory Comp, - 9, 4046, 2013. +**(Shi)** Shi, Xiz, Znahg, Best, Wu, Ponder, Ren, J Chem Theory Comp, 9, 4046, 2013. .. _amoeba-Rackers: From ab73faee095419dbf80733bd64745880c0bab53a Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Tue, 19 Apr 2022 11:33:59 -0600 Subject: [PATCH 133/585] Removed EPS trick that was causing some unexpected reordering --- src/compute_grid_local.cpp | 20 ++++++++++---------- 1 file changed, 10 insertions(+), 10 deletions(-) diff --git a/src/compute_grid_local.cpp b/src/compute_grid_local.cpp index 299e42d81d..ec385f6a13 100644 --- a/src/compute_grid_local.cpp +++ b/src/compute_grid_local.cpp @@ -191,18 +191,18 @@ void ComputeGridLocal::set_grid_local() zfrachi = comm->mysplit[2][1]; } - // not fully clear why this works - // without, sometimes get uneven assignments - // in case where ngridz is multiple of nprocz + // // not fully clear why this works + // // without, sometimes get uneven assignments + // // in case where ngridz is multiple of nprocz - double MYEPS = 1.0e-10; + // double MYEPS = 1.0e-10; - xfraclo += MYEPS; - xfrachi += MYEPS; - yfraclo += MYEPS; - yfrachi += MYEPS; - zfraclo += MYEPS; - zfrachi += MYEPS; + // xfraclo += MYEPS; + // xfrachi += MYEPS; + // yfraclo += MYEPS; + // yfrachi += MYEPS; + // zfraclo += MYEPS; + // zfrachi += MYEPS; nxlo = static_cast (xfraclo * nx); if (1.0*nxlo != xfraclo*nx) nxlo++; From 4c5782018897874fe3c11ac50757d505d7239885 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Tue, 19 Apr 2022 11:48:16 -0600 Subject: [PATCH 134/585] Applied the Modine transpose to x,y,z --- src/compute_grid_local.cpp | 8 ++++---- 1 file changed, 4 insertions(+), 4 deletions(-) diff --git a/src/compute_grid_local.cpp b/src/compute_grid_local.cpp index ec385f6a13..0d8738e230 100644 --- a/src/compute_grid_local.cpp +++ b/src/compute_grid_local.cpp @@ -230,9 +230,9 @@ void ComputeGridLocal::set_grid_local() void ComputeGridLocal::assign_coords() { int igrid = 0; - for (int iz = nzlo; iz <= nzhi; iz++) + for (int ix = nxlo; ix <= nxhi; ix++) for (int iy = nylo; iy <= nyhi; iy++) - for (int ix = nxlo; ix <= nxhi; ix++) { + for (int iz = nzlo; iz <= nzhi; iz++) { alocal[igrid][0] = ix; alocal[igrid][1] = iy; alocal[igrid][2] = iz; @@ -260,9 +260,9 @@ void ComputeGridLocal::assign_coords() void ComputeGridLocal::copy_gridlocal_to_local_array() { int igrid = 0; - for (int iz = nzlo; iz <= nzhi; iz++) + for (int ix = nxlo; ix <= nxhi; ix++) for (int iy = nylo; iy <= nyhi; iy++) - for (int ix = nxlo; ix <= nxhi; ix++) { + for (int iz = nzlo; iz <= nzhi; iz++) { for (int icol = size_local_cols_base; icol < size_local_cols; icol++) alocal[igrid][icol] = gridlocal[icol][iz][iy][ix]; igrid++; From cc5bfd934dba0fef3d29951a160116c455b5a4dc Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Tue, 19 Apr 2022 11:49:55 -0600 Subject: [PATCH 135/585] change tagint to double storage --- examples/amoeba/in.ubiquitin | 2 +- examples/amoeba/in.water_box.amoeba | 2 +- examples/amoeba/in.water_box.hippo | 2 +- examples/amoeba/in.water_dimer.amoeba | 2 +- examples/amoeba/in.water_dimer.hippo | 2 +- examples/amoeba/in.water_hexamer.amoeba | 2 +- examples/amoeba/in.water_hexamer.hippo | 2 +- src/AMOEBA/amoeba_hal.cpp | 4 +- src/AMOEBA/amoeba_induce.cpp | 6 +- src/AMOEBA/amoeba_multipole.cpp | 3 +- src/AMOEBA/amoeba_polar.cpp | 3 +- src/AMOEBA/amoeba_utils.cpp | 101 +++++++++++++----------- src/AMOEBA/pair_amoeba.cpp | 43 +++++----- src/AMOEBA/pair_amoeba.h | 11 +-- 14 files changed, 92 insertions(+), 93 deletions(-) diff --git a/examples/amoeba/in.ubiquitin b/examples/amoeba/in.ubiquitin index 9f3fefba73..ef6f55c6da 100644 --- a/examples/amoeba/in.ubiquitin +++ b/examples/amoeba/in.ubiquitin @@ -20,7 +20,7 @@ fix bit all amoeba/bitorsion bitorsion.ubiquitin.data fix_modify bit energy yes fix extra all property/atom & - i_amgroup i_ired i_xaxis i_yaxis i_zaxis d_pval ghost yes + i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes fix extra2 all property/atom i_polaxe #read_data data.ubiquitin fix amtype NULL "Tinker Types" diff --git a/examples/amoeba/in.water_box.amoeba b/examples/amoeba/in.water_box.amoeba index 3a37784f9d..1e1a72463e 100644 --- a/examples/amoeba/in.water_box.amoeba +++ b/examples/amoeba/in.water_box.amoeba @@ -12,7 +12,7 @@ dihedral_style none fix amtype all property/atom i_amtype ghost yes fix extra all property/atom & - i_amgroup i_ired i_xaxis i_yaxis i_zaxis d_pval ghost yes + i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes fix extra2 all property/atom i_polaxe # read data file diff --git a/examples/amoeba/in.water_box.hippo b/examples/amoeba/in.water_box.hippo index 8e1d9a8e70..49acb58317 100644 --- a/examples/amoeba/in.water_box.hippo +++ b/examples/amoeba/in.water_box.hippo @@ -12,7 +12,7 @@ dihedral_style none fix amtype all property/atom i_amtype ghost yes fix extra all property/atom & - i_amgroup i_ired i_xaxis i_yaxis i_zaxis d_pval ghost yes + i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes fix extra2 all property/atom i_polaxe # read data file diff --git a/examples/amoeba/in.water_dimer.amoeba b/examples/amoeba/in.water_dimer.amoeba index c0e6ee35e4..9e9cae8ac3 100644 --- a/examples/amoeba/in.water_dimer.amoeba +++ b/examples/amoeba/in.water_dimer.amoeba @@ -12,7 +12,7 @@ dihedral_style none fix amtype all property/atom i_amtype ghost yes fix extra all property/atom & - i_amgroup i_ired i_xaxis i_yaxis i_zaxis d_pval ghost yes + i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes fix extra2 all property/atom i_polaxe # read data file diff --git a/examples/amoeba/in.water_dimer.hippo b/examples/amoeba/in.water_dimer.hippo index 55b173b789..1e9755570a 100644 --- a/examples/amoeba/in.water_dimer.hippo +++ b/examples/amoeba/in.water_dimer.hippo @@ -12,7 +12,7 @@ dihedral_style none fix amtype all property/atom i_amtype ghost yes fix extra all property/atom & - i_amgroup i_ired i_xaxis i_yaxis i_zaxis d_pval ghost yes + i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes fix extra2 all property/atom i_polaxe # read data file diff --git a/examples/amoeba/in.water_hexamer.amoeba b/examples/amoeba/in.water_hexamer.amoeba index eb16206f45..0ce596a06c 100644 --- a/examples/amoeba/in.water_hexamer.amoeba +++ b/examples/amoeba/in.water_hexamer.amoeba @@ -12,7 +12,7 @@ dihedral_style none fix amtype all property/atom i_amtype ghost yes fix extra all property/atom & - i_amgroup i_ired i_xaxis i_yaxis i_zaxis d_pval ghost yes + i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes fix extra2 all property/atom i_polaxe # read data file diff --git a/examples/amoeba/in.water_hexamer.hippo b/examples/amoeba/in.water_hexamer.hippo index 1287a1f527..52f6e863a2 100644 --- a/examples/amoeba/in.water_hexamer.hippo +++ b/examples/amoeba/in.water_hexamer.hippo @@ -12,7 +12,7 @@ dihedral_style none fix amtype all property/atom i_amtype ghost yes fix extra all property/atom & - i_amgroup i_ired i_xaxis i_yaxis i_zaxis d_pval ghost yes + i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes fix extra2 all property/atom i_polaxe # read data file diff --git a/src/AMOEBA/amoeba_hal.cpp b/src/AMOEBA/amoeba_hal.cpp index f402221520..01123251e7 100644 --- a/src/AMOEBA/amoeba_hal.cpp +++ b/src/AMOEBA/amoeba_hal.cpp @@ -152,8 +152,8 @@ void PairAmoeba::hal() // increment the total van der Waals energy and derivatives // if jv < 0, trigger an error, needed H-bond partner is missing - iv = ired2local[i]; - jv = ired2local[j]; + iv = red2local[i]; + jv = red2local[j]; if (jv < 0) error->one(FLERR,"AMOEBA hal cannot find H bond partner - " "ghost comm is too short"); diff --git a/src/AMOEBA/amoeba_induce.cpp b/src/AMOEBA/amoeba_induce.cpp index beac1186f7..cbd0a2c480 100644 --- a/src/AMOEBA/amoeba_induce.cpp +++ b/src/AMOEBA/amoeba_induce.cpp @@ -772,8 +772,7 @@ void PairAmoeba::uscale0b(int mode, double **rsd, double **rsdp, // owned atoms - pval = atom->dvector[index_pval]; - + double *pval = atom->dvector[index_pval]; double **x = atom->x; int nlocal = atom->nlocal; int nall = nlocal + atom->nghost; @@ -1441,9 +1440,8 @@ void PairAmoeba::udirect2b(double **field, double **fieldp) // owned atoms - pval = atom->dvector[index_pval]; - double **x = atom->x; + double *pval = atom->dvector[index_pval]; // neigh list diff --git a/src/AMOEBA/amoeba_multipole.cpp b/src/AMOEBA/amoeba_multipole.cpp index d0a59a7a0b..5f66f41deb 100644 --- a/src/AMOEBA/amoeba_multipole.cpp +++ b/src/AMOEBA/amoeba_multipole.cpp @@ -193,8 +193,7 @@ void PairAmoeba::multipole_real() // owned atoms - pval = atom->dvector[index_pval]; - + double *pval = atom->dvector[index_pval]; double **x = atom->x; double **f = atom->f; int nlocal = atom->nlocal; diff --git a/src/AMOEBA/amoeba_polar.cpp b/src/AMOEBA/amoeba_polar.cpp index 0e9b5250f3..da84053f0d 100644 --- a/src/AMOEBA/amoeba_polar.cpp +++ b/src/AMOEBA/amoeba_polar.cpp @@ -275,8 +275,7 @@ void PairAmoeba::polar_real() // owned atoms - pval = atom->dvector[index_pval]; - + double *pval = atom->dvector[index_pval]; double **x = atom->x; double **f = atom->f; int nlocal = atom->nlocal; diff --git a/src/AMOEBA/amoeba_utils.cpp b/src/AMOEBA/amoeba_utils.cpp index e7eb99cced..b1be3ef30b 100644 --- a/src/AMOEBA/amoeba_utils.cpp +++ b/src/AMOEBA/amoeba_utils.cpp @@ -51,11 +51,10 @@ void PairAmoeba::kmpole() tagint angleneigh[36]; amtype = atom->ivector[index_amtype]; - xaxis = atom->ivector[index_xaxis]; - yaxis = atom->ivector[index_yaxis]; - zaxis = atom->ivector[index_zaxis]; - polaxe = atom->ivector[index_polaxe]; - + int *polaxe = atom->ivector[index_polaxe]; + double *xaxis = atom->dvector[index_xaxis]; + double *yaxis = atom->dvector[index_yaxis]; + double *zaxis = atom->dvector[index_zaxis]; double **pole = fixpole->astore; int **nspecial = atom->nspecial; @@ -126,9 +125,9 @@ void PairAmoeba::kmpole() if (ktype == xtype) { if (ytype == 0 && !flag) { flag = 1; - zaxis[i] = jneigh; - xaxis[i] = kneigh; - yaxis[i] = 0; + zaxis[i] = ubuf(jneigh).d; + xaxis[i] = ubuf(kneigh).d; + yaxis[i] = 0.0; polaxe[i] = mpaxis[itype][iframe]; for (j = 0; j < 13; j++) pole[i][j] = fpole[itype][iframe][j]; @@ -142,9 +141,9 @@ void PairAmoeba::kmpole() mtype = amtype[m]; if (mtype == ytype && !flag) { flag = 1; - zaxis[i] = jneigh; - xaxis[i] = kneigh; - yaxis[i] = mneigh; + zaxis[i] = ubuf(jneigh).d; + xaxis[i] = ubuf(kneigh).d; + yaxis[i] = ubuf(mneigh).d; polaxe[i] = mpaxis[itype][iframe]; for (j = 0; j < 13; j++) pole[i][j] = fpole[itype][iframe][j]; @@ -184,9 +183,9 @@ void PairAmoeba::kmpole() if (ktype == xtype) { if (ytype == 0 && !flag) { flag = 1; - zaxis[i] = jneigh; - xaxis[i] = kneigh; - yaxis[i] = 0; + zaxis[i] = ubuf(jneigh).d; + xaxis[i] = ubuf(kneigh).d; + yaxis[i] = 0.0; polaxe[i] = mpaxis[itype][iframe]; for (j = 0; j < 13; j++) pole[i][j] = fpole[itype][iframe][j]; @@ -204,9 +203,9 @@ void PairAmoeba::kmpole() if (!path) continue; if (mtype == ytype && !flag) { flag = 1; - zaxis[i] = jneigh; - xaxis[i] = kneigh; - yaxis[i] = mneigh; + zaxis[i] = ubuf(jneigh).d; + xaxis[i] = ubuf(kneigh).d; + yaxis[i] = ubuf(mneigh).d; polaxe[i] = mpaxis[itype][iframe]; for (j = 0; j < 13; j++) pole[i][j] = fpole[itype][iframe][j]; @@ -235,8 +234,8 @@ void PairAmoeba::kmpole() if (jtype == ztype) { if (xtype == 0 && !flag) { flag = 1; - zaxis[i] = jtype; - xaxis[i] = yaxis[i] = 0; + zaxis[i] = ubuf(jneigh).d; + xaxis[i] = yaxis[i] = 0.0; polaxe[i] = mpaxis[itype][iframe]; for (j = 0; j < 13; j++) pole[i][j] = fpole[itype][iframe][j]; @@ -255,7 +254,7 @@ void PairAmoeba::kmpole() ztype = zpole[itype][iframe]; if (ztype == 0 && !flag) { flag = 1; - zaxis[i] = xaxis[i] = yaxis[i] = 0; + zaxis[i] = xaxis[i] = yaxis[i] = 0.0; polaxe[i] = mpaxis[itype][iframe]; for (j = 0; j < 13; j++) pole[i][j] = fpole[itype][iframe][j]; @@ -295,15 +294,18 @@ void PairAmoeba::chkpole(int i) double xcd,ycd,zcd; double c1,c2,c3,vol; - polaxe = atom->ivector[index_polaxe]; double **pole = fixpole->astore; + int *polaxe = atom->ivector[index_polaxe]; + double *yaxis = atom->dvector[index_yaxis]; + tagint yaxisID = (tagint) ubuf(yaxis[i]).i; + // test for chirality inversion // if not, return check = true; if (polaxe[i] != ZTHENX) check = false; - if (yaxis[i] == 0) check = false; + if (yaxisID == 0) check = false; if (!check) return; ib = zaxis2local[i]; @@ -331,9 +333,8 @@ void PairAmoeba::chkpole(int i) // invert atomic multipole components involving the y-axis // flip sign in permanent yaxis, not yaxis2local - int k = yaxis[i]; - if ((k < 0 && vol > 0.0) || (k > 0 && vol < 0.0)) { - yaxis[i] = -k; + if ((yaxisID < 0 && vol > 0.0) || (yaxisID > 0 && vol < 0.0)) { + yaxis[i] = -ubuf(yaxisID).d; pole[i][2] = -pole[i][2]; pole[i][5] = -pole[i][5]; pole[i][7] = -pole[i][7]; @@ -359,7 +360,7 @@ void PairAmoeba::rotmat(int i) double dx2,dy2,dz2; double dx3,dy3,dz3; - polaxe = atom->ivector[index_polaxe]; + int *polaxe = atom->ivector[index_polaxe]; // get coordinates and frame definition for the multipole site @@ -671,32 +672,34 @@ void PairAmoeba::add_onefive_neighbors() /* ---------------------------------------------------------------------- update local indices of hydrogen neighbors for owned and ghost atoms - ired2local = used for offset of hydrogen positions in Vdwl term + red2local = used for offset of hydrogen positions in Vdwl term called on reneighboring steps, only for AMOEBA ------------------------------------------------------------------------- */ void PairAmoeba::find_hydrogen_neighbors() { int index; + tagint id; - // grab current ptr for ired - // ired[i] = atom ID that atom I is bonded to - // ired2local[i] = local index of that atom + // grab current ptr for redID + // redID[i] = atom ID that atom I is bonded to + // red2local[i] = local index of that atom // for furthest away ghost atoms, bond partner can be missing - // in that case ired2local = -1, but only an error if accessed in hal() + // in that case red2local = -1, but only an error if accessed in hal() - ired = atom->ivector[index_ired]; + double *redID = atom->dvector[index_redID]; int nlocal = atom->nlocal; int nall = nlocal + atom->nghost; int nmissing = 0; for (int i = 0; i < nall; i++) { - if (ired[i] == 0) ired2local[i] = i; + if (redID[i] == 0.0) red2local[i] = i; else { - index = atom->map(ired[i]); + id = (tagint) ubuf(redID[i]).i; + index = atom->map(id); if (index >= 0) index = domain->closest_image(i,index); - ired2local[i] = index; + red2local[i] = index; } } } @@ -710,22 +713,27 @@ void PairAmoeba::find_hydrogen_neighbors() void PairAmoeba::find_multipole_neighbors() { int index,ypos; + tagint xaxisID,yaxisID,zaxisID; // grab current pts for xaxis,yaxis,zaxis // xyz axis[i] = atom IDs that atom I uses for its multipole orientation // can be zero if not used, in which case set local index to self // yaxis can be negative, in which case use absolute value - xaxis = atom->ivector[index_xaxis]; - yaxis = atom->ivector[index_yaxis]; - zaxis = atom->ivector[index_zaxis]; + double *xaxis = atom->dvector[index_xaxis]; + double *yaxis = atom->dvector[index_yaxis]; + double *zaxis = atom->dvector[index_zaxis]; int nlocal = atom->nlocal; int nmissing = 0; for (int i = 0; i < nlocal; i++) { - if (xaxis[i]) { - index = atom->map(xaxis[i]); + xaxisID = (tagint) ubuf(xaxis[i]).i; + yaxisID = (tagint) ubuf(yaxis[i]).i; + zaxisID = (tagint) ubuf(zaxis[i]).i; + + if (xaxisID) { + index = atom->map(xaxisID); if (index == -1) nmissing++; else { index = domain->closest_image(i,index); @@ -733,10 +741,9 @@ void PairAmoeba::find_multipole_neighbors() } } else xaxis2local[i] = i; - if (yaxis[i]) { - if (yaxis[i] > 0) ypos = yaxis[i]; - else ypos = -yaxis[i]; - index = atom->map(ypos); + if (yaxisID) { + if (yaxis[i] < 0) yaxisID = -yaxisID; + index = atom->map(yaxisID); if (index == -1) nmissing++; else { index = domain->closest_image(i,index); @@ -744,8 +751,8 @@ void PairAmoeba::find_multipole_neighbors() } } else yaxis2local[i] = i; - if (zaxis[i]) { - index = atom->map(zaxis[i]); + if (zaxisID) { + index = atom->map(zaxisID); if (index == -1) nmissing++; else { index = domain->closest_image(i,index); @@ -838,7 +845,7 @@ void PairAmoeba::torque2force(int i, double *trq, // get the local frame type and the frame-defining atoms - polaxe = atom->ivector[index_polaxe]; + int *polaxe = atom->ivector[index_polaxe]; axetyp = polaxe[i]; if (axetyp == NOFRAME) return; diff --git a/src/AMOEBA/pair_amoeba.cpp b/src/AMOEBA/pair_amoeba.cpp index 17ea496480..6869aa57e4 100644 --- a/src/AMOEBA/pair_amoeba.cpp +++ b/src/AMOEBA/pair_amoeba.cpp @@ -84,7 +84,7 @@ PairAmoeba::PairAmoeba(LAMMPS *lmp) : Pair(lmp) rpole = NULL; tq = NULL; - ired2local = NULL; + red2local = NULL; xred = NULL; uind = uinp = udirp = NULL; @@ -166,7 +166,7 @@ PairAmoeba::~PairAmoeba() memory->destroy(rpole); memory->destroy(tq); - memory->destroy(ired2local); + memory->destroy(red2local); memory->destroy(xred); memory->destroy(uind); @@ -289,7 +289,7 @@ void PairAmoeba::compute(int eflag, int vflag) kmpole(); if (hippo) { - pval = atom->dvector[index_pval]; + double *pval = atom->dvector[index_pval]; double **pole = fixpole->astore; int nlocal = atom->nlocal; int itype,iclass; @@ -316,7 +316,7 @@ void PairAmoeba::compute(int eflag, int vflag) // if reneighboring step: // augment neighbor list to include 1-5 neighbor flags - // re-create xyz axis2local and ired2local + // re-create xyz axis2local and red2local // re-create induce neighbor list if (neighbor->ago == 0) { @@ -341,7 +341,7 @@ void PairAmoeba::compute(int eflag, int vflag) int nlocal = atom->nlocal; for (int i = 0; i < nlocal; i++) { - j = ired2local[i]; + j = red2local[i]; iclass = amtype2class[amtype[i]]; rdn = kred[iclass]; xred[i][0] = rdn*(x[i][0]-x[j][0]) + x[j][0]; @@ -707,17 +707,17 @@ void PairAmoeba::init_style() if (index_amgroup < 0 || flag || cols) error->all(FLERR,"Pair amoeba amgroup is not defined"); - index_ired = atom->find_custom("ired",flag,cols); - if (index_ired < 0 || flag || cols) - error->all(FLERR,"Pair amoeba ired is not defined"); + index_redID = atom->find_custom("redID",flag,cols); + if (index_redID < 0 || !flag || cols) + error->all(FLERR,"Pair amoeba redID is not defined"); index_xaxis = atom->find_custom("xaxis",flag,cols); - if (index_xaxis < 0 || flag || cols) + if (index_xaxis < 0 || !flag || cols) error->all(FLERR,"Pair amoeba xaxis is not defined"); index_yaxis = atom->find_custom("yaxis",flag,cols); - if (index_yaxis < 0 || flag || cols) + if (index_yaxis < 0 || !flag || cols) error->all(FLERR,"Pair amoeba yaxis is not defined"); index_zaxis = atom->find_custom("zaxis",flag,cols); - if (index_zaxis < 0 || flag || cols) + if (index_zaxis < 0 || !flag || cols) error->all(FLERR,"Pair amoeba zaxis is not defined"); index_polaxe = atom->find_custom("polaxe",flag,cols); @@ -879,7 +879,7 @@ void PairAmoeba::init_style() // pval is not set until first call to compute(), and only for HIPPO if (first_flag) { - pval = atom->dvector[index_pval]; + double *pval = atom->dvector[index_pval]; int nlocal = atom->nlocal; for (int i = 0; i < nlocal; i++) pval[i] = 0.0; } @@ -918,14 +918,13 @@ void PairAmoeba::init_style() fixupalt = (FixStore *) modify->fix[ifix]; } - // assign hydrogen neighbors (ired) to each owned atom + // assign hydrogen neighbors (redID) to each owned atom // only set if kred[i] is non-zero and I is bonded to a single atom - // conceptually: non-zero if I is a hydrogen bonded to another atom - // NOTE: ired needs to be a tagint vector? but atom ivector is not! + // conceptually: non-zero if I is hydrogen bonded to another atom if (amoeba) { amtype = atom->ivector[index_amtype]; - ired = atom->ivector[index_ired]; + double *redID = atom->dvector[index_redID]; int **nspecial = atom->nspecial; tagint **special = atom->special; @@ -937,13 +936,13 @@ void PairAmoeba::init_style() itype = amtype[i]; iclass = amtype2class[itype]; if (kred[iclass] == 0.0) { - ired[i] = 0; + redID[i] = 0.0; } else if (nspecial[i][0] != 1) { - ired[i] = 0; + redID[i] = 0.0; } else { - ired[i] = special[i][0]; + redID[i] = ubuf(special[i][0]).d; } } } @@ -1207,6 +1206,7 @@ int PairAmoeba::pack_forward_comm(int n, int *list, double *buf, } } else if (cfstyle == PVAL) { + double *pval = atom->dvector[index_pval]; for (i = 0; i < n; i++) { j = list[i]; buf[m++] = pval[j]; @@ -1310,6 +1310,7 @@ void PairAmoeba::unpack_forward_comm(int n, int first, double *buf) } } else if (cfstyle == PVAL) { + double *pval = atom->dvector[index_pval]; for (i = first; i < last; i++) { pval[i] = buf[m++]; } @@ -2112,7 +2113,7 @@ void PairAmoeba::grow_local() memory->destroy(tq); if (amoeba) { - memory->destroy(ired2local); + memory->destroy(red2local); memory->destroy(xred); } @@ -2163,7 +2164,7 @@ void PairAmoeba::grow_local() memory->create(tq,nmax,3,"amoeba:tq"); if (amoeba) { - memory->create(ired2local,nmax,"amoeba:ired2local"); + memory->create(red2local,nmax,"amoeba:red2local"); memory->create(xred,nmax,3,"amoeba:xred"); } diff --git a/src/AMOEBA/pair_amoeba.h b/src/AMOEBA/pair_amoeba.h index 15ba4d8526..0057219b98 100644 --- a/src/AMOEBA/pair_amoeba.h +++ b/src/AMOEBA/pair_amoeba.h @@ -158,16 +158,11 @@ class PairAmoeba : public Pair { // static per-atom properties, must persist as atoms migrate - int index_amtype,index_amgroup,index_ired; - int index_xaxis,index_yaxis,index_zaxis; - int index_polaxe,index_pval; + int index_amtype,index_amgroup,index_redID; + int index_xaxis,index_yaxis,index_zaxis,index_polaxe,index_pval; int *amtype; // AMOEBA type, 1 to N_amtype int *amgroup; // AMOEBA polarization group, 1 to Ngroup - tagint *ired; // ID of atom that H is bonded to - tagint *xaxis,*yaxis,*zaxis; // IDs of nearby atoms for multipole def - int *polaxe; - double *pval; char *id_pole,*id_udalt,*id_upalt; class FixStore *fixpole; // stores pole = multipole components @@ -252,7 +247,7 @@ class PairAmoeba : public Pair { // just for owned atoms // set to self if not defined - int *ired2local; // local indices of ired IDs, computed for owned and ghost + int *red2local; // local indices of ired IDs, computed for owned and ghost double **xred; // altered coords for H atoms for Vdwl, comm to ghosts double **tq; // torque from pairwise multipole, reverse comm from ghosts From e20892fc89d3a7605ea3f8f4d8617557b66f225a Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Tue, 19 Apr 2022 15:35:26 -0600 Subject: [PATCH 136/585] one more tagint change --- src/AMOEBA/amoeba_utils.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/AMOEBA/amoeba_utils.cpp b/src/AMOEBA/amoeba_utils.cpp index b1be3ef30b..c52b8bbcac 100644 --- a/src/AMOEBA/amoeba_utils.cpp +++ b/src/AMOEBA/amoeba_utils.cpp @@ -622,7 +622,7 @@ void PairAmoeba::add_onefive_neighbors() int i,j,k,ii,jj,which,inum,jnum,n15; tagint jtag; int *ilist,*jlist,*numneigh,**firstneigh; - int *list15; + tagint *list15; // test for overflow of reduced allowed size of neighbor list From a51749b3e9e986b8638807e2b1b95102ae46cfd3 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Tue, 19 Apr 2022 16:30:32 -0600 Subject: [PATCH 137/585] force sign flip in improper amoeba --- src/AMOEBA/improper_amoeba.cpp | 32 ++++++++++++-------------------- 1 file changed, 12 insertions(+), 20 deletions(-) diff --git a/src/AMOEBA/improper_amoeba.cpp b/src/AMOEBA/improper_amoeba.cpp index ad7e26d97e..63409dd1ab 100644 --- a/src/AMOEBA/improper_amoeba.cpp +++ b/src/AMOEBA/improper_amoeba.cpp @@ -201,38 +201,30 @@ void ImproperAmoeba::compute(int eflag, int vflag) fb[1] = -fa[1] - fc[1] - fd[1]; fb[2] = -fa[2] - fc[2] - fd[2]; - /* - printf("IMP DBAC %d %d %d %d: angle %g eng %g dedcos %g " - "fD %g %g %g fA %g %g %g fC %g %g %g\n", - atom->tag[id],atom->tag[ib],atom->tag[ia],atom->tag[ic], - angle,e,dedcos,fd[0],fd[1],fd[2],fa[0],fa[1],fa[2], - fc[0],fc[1],fc[2]); - */ - // apply force to each of 4 atoms if (newton_bond || id < nlocal) { - f[id][0] += fd[0]; - f[id][1] += fd[1]; - f[id][2] += fd[2]; + f[id][0] -= fd[0]; + f[id][1] -= fd[1]; + f[id][2] -= fd[2]; } if (newton_bond || ib < nlocal) { - f[ib][0] += fb[0]; - f[ib][1] += fb[1]; - f[ib][2] += fb[2]; + f[ib][0] -= fb[0]; + f[ib][1] -= fb[1]; + f[ib][2] -= fb[2]; } if (newton_bond || ia < nlocal) { - f[ia][0] += fa[0]; - f[ia][1] += fa[1]; - f[ia][2] += fa[2]; + f[ia][0] -= fa[0]; + f[ia][1] -= fa[1]; + f[ia][2] -= fa[2]; } if (newton_bond || ic < nlocal) { - f[ic][0] += fc[0]; - f[ic][1] += fc[1]; - f[ic][2] += fc[2]; + f[ic][0] -= fc[0]; + f[ic][1] -= fc[1]; + f[ic][2] -= fc[2]; } if (evflag) From cfff30130f241434257c1794f30c9d63260d0c7f Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Tue, 19 Apr 2022 16:33:54 -0600 Subject: [PATCH 138/585] tagint change --- src/AMOEBA/atom_vec_amoeba.h | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/AMOEBA/atom_vec_amoeba.h b/src/AMOEBA/atom_vec_amoeba.h index 8953023550..4de18f7261 100644 --- a/src/AMOEBA/atom_vec_amoeba.h +++ b/src/AMOEBA/atom_vec_amoeba.h @@ -39,7 +39,7 @@ class AtomVecAmoeba : public AtomVec { int *num_bond,*num_angle,*num_dihedral,*num_improper; int **bond_type,**angle_type,**dihedral_type,**improper_type; int **nspecial; - int *nspecial15,**special15; + int *nspecial15; int any_bond_negative,any_angle_negative, any_dihedral_negative,any_improper_negative; From ee74d9761c89e1c2f0471a1f5a026af28945035e Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Wed, 20 Apr 2022 09:41:06 -0600 Subject: [PATCH 139/585] reorder pitorsion atoms --- examples/amoeba/data.ubiquitin | 212 ++++++++++++++++----------------- tools/tinker/tinker2lmp.py | 3 +- 2 files changed, 108 insertions(+), 107 deletions(-) diff --git a/examples/amoeba/data.ubiquitin b/examples/amoeba/data.ubiquitin index aada520e6d..653cbc3639 100644 --- a/examples/amoeba/data.ubiquitin +++ b/examples/amoeba/data.ubiquitin @@ -26425,112 +26425,112 @@ BiTorsions PiTorsions -1 1 2 4 3 20 21 24 -2 1 21 23 22 37 38 41 -3 1 27 29 28 30 35 36 -4 1 38 40 39 56 57 60 -5 1 57 59 58 76 77 80 -6 2 62 65 63 64 66 71 -7 2 62 64 63 65 67 72 -8 2 63 71 64 66 68 73 -9 2 63 72 65 67 68 74 -10 2 64 73 66 68 67 75 -11 2 65 74 67 68 66 75 -12 1 77 79 78 92 93 96 -13 1 93 95 94 114 115 118 -14 1 115 117 116 128 129 132 -15 1 129 131 130 147 148 151 -16 1 148 150 149 161 162 165 -17 1 162 164 163 168 169 172 -18 1 169 171 170 190 191 194 -19 1 191 193 192 204 205 208 -20 1 205 207 206 223 224 227 -21 1 224 226 225 237 238 241 -22 1 238 240 239 256 257 260 -23 1 257 259 258 271 272 275 -24 1 272 274 273 287 288 291 -25 3 288 290 289 302 303 309 -26 1 303 305 304 316 317 320 -27 1 317 319 318 327 328 331 -28 1 328 330 329 339 340 343 -29 1 340 342 341 353 354 357 -30 1 354 356 355 372 373 376 -31 1 373 375 374 387 388 391 -32 1 388 390 389 401 402 405 -33 1 393 395 394 396 399 400 -34 1 402 404 403 417 418 421 -35 1 418 420 419 439 440 443 -36 1 440 442 441 449 450 453 -37 1 450 452 451 471 472 475 -38 1 472 474 473 490 491 494 -39 1 491 493 492 507 508 511 -40 1 497 499 498 500 505 506 -41 1 508 510 509 519 520 523 -42 1 520 522 521 541 542 545 -43 1 542 544 543 556 557 560 -44 1 557 559 558 563 564 567 -45 3 564 566 565 582 583 589 -46 3 583 585 584 596 597 603 -47 1 597 599 598 610 611 614 -48 1 611 613 612 622 623 626 -49 1 623 625 624 639 640 643 -50 1 629 631 630 632 637 638 -51 1 640 642 641 656 657 660 -52 1 646 648 647 649 654 655 -53 1 657 659 658 680 681 684 -54 1 681 683 682 699 700 703 -55 1 700 702 701 718 719 722 -56 1 719 721 720 738 739 742 -57 2 724 727 725 726 728 733 -58 2 724 726 725 727 729 734 -59 2 725 733 726 728 730 735 -60 2 725 734 727 729 730 736 -61 2 726 735 728 730 729 737 -62 2 727 736 729 730 728 737 -63 1 739 741 740 748 749 752 -64 1 749 751 750 755 756 759 -65 1 756 758 757 777 778 781 -66 1 778 780 779 794 795 798 -67 1 784 786 785 787 792 793 -68 1 795 797 796 813 814 817 -69 1 814 816 815 828 829 832 -70 1 829 831 830 840 841 844 -71 1 841 843 842 847 848 851 -72 1 848 850 849 871 872 875 -73 1 872 874 873 885 886 889 -74 1 886 888 887 904 905 908 -75 1 905 907 906 915 916 919 -76 1 916 918 917 927 928 931 -77 1 928 930 929 948 949 952 -78 2 933 936 934 935 937 943 -79 2 933 935 934 936 938 944 -80 2 934 943 935 937 939 945 -81 2 934 944 936 938 939 946 -82 2 935 945 937 939 938 940 -83 2 936 946 938 939 937 940 -84 1 949 951 950 962 963 966 -85 1 954 956 955 957 960 961 -86 1 963 965 964 981 982 985 -87 1 982 984 983 998 999 1002 -88 1 988 990 989 991 996 997 -89 1 999 1001 1000 1020 1021 1024 -90 1 1021 1023 1022 1035 1036 1039 -91 1 1036 1038 1037 1046 1047 1050 -92 1 1047 1049 1048 1060 1061 1064 -93 1 1061 1063 1062 1079 1080 1083 -94 1 1080 1082 1081 1097 1098 1101 -95 4 1085 1088 1086 1087 1089 1093 -96 5 1085 1087 1086 1088 1090 1094 -97 6 1086 1093 1087 1089 1090 1095 -98 4 1086 1094 1088 1090 1089 1096 -99 6 1087 1095 1089 1090 1088 1096 -100 1 1098 1100 1099 1116 1117 1120 -101 1 1117 1119 1118 1132 1133 1136 -102 1 1133 1135 1134 1151 1152 1155 -103 1 1152 1154 1153 1175 1176 1179 -104 1 1176 1178 1177 1194 1195 1198 -105 1 1195 1197 1196 1218 1219 1222 -106 1 1219 1221 1220 1225 1226 1229 +1 1 2 4 3 20 24 21 +2 1 21 23 22 37 41 38 +3 1 27 29 28 30 36 35 +4 1 38 40 39 56 60 57 +5 1 57 59 58 76 80 77 +6 2 62 65 63 64 71 66 +7 2 62 64 63 65 72 67 +8 2 63 71 64 66 73 68 +9 2 63 72 65 67 74 68 +10 2 64 73 66 68 75 67 +11 2 65 74 67 68 75 66 +12 1 77 79 78 92 96 93 +13 1 93 95 94 114 118 115 +14 1 115 117 116 128 132 129 +15 1 129 131 130 147 151 148 +16 1 148 150 149 161 165 162 +17 1 162 164 163 168 172 169 +18 1 169 171 170 190 194 191 +19 1 191 193 192 204 208 205 +20 1 205 207 206 223 227 224 +21 1 224 226 225 237 241 238 +22 1 238 240 239 256 260 257 +23 1 257 259 258 271 275 272 +24 1 272 274 273 287 291 288 +25 3 288 290 289 302 309 303 +26 1 303 305 304 316 320 317 +27 1 317 319 318 327 331 328 +28 1 328 330 329 339 343 340 +29 1 340 342 341 353 357 354 +30 1 354 356 355 372 376 373 +31 1 373 375 374 387 391 388 +32 1 388 390 389 401 405 402 +33 1 393 395 394 396 400 399 +34 1 402 404 403 417 421 418 +35 1 418 420 419 439 443 440 +36 1 440 442 441 449 453 450 +37 1 450 452 451 471 475 472 +38 1 472 474 473 490 494 491 +39 1 491 493 492 507 511 508 +40 1 497 499 498 500 506 505 +41 1 508 510 509 519 523 520 +42 1 520 522 521 541 545 542 +43 1 542 544 543 556 560 557 +44 1 557 559 558 563 567 564 +45 3 564 566 565 582 589 583 +46 3 583 585 584 596 603 597 +47 1 597 599 598 610 614 611 +48 1 611 613 612 622 626 623 +49 1 623 625 624 639 643 640 +50 1 629 631 630 632 638 637 +51 1 640 642 641 656 660 657 +52 1 646 648 647 649 655 654 +53 1 657 659 658 680 684 681 +54 1 681 683 682 699 703 700 +55 1 700 702 701 718 722 719 +56 1 719 721 720 738 742 739 +57 2 724 727 725 726 733 728 +58 2 724 726 725 727 734 729 +59 2 725 733 726 728 735 730 +60 2 725 734 727 729 736 730 +61 2 726 735 728 730 737 729 +62 2 727 736 729 730 737 728 +63 1 739 741 740 748 752 749 +64 1 749 751 750 755 759 756 +65 1 756 758 757 777 781 778 +66 1 778 780 779 794 798 795 +67 1 784 786 785 787 793 792 +68 1 795 797 796 813 817 814 +69 1 814 816 815 828 832 829 +70 1 829 831 830 840 844 841 +71 1 841 843 842 847 851 848 +72 1 848 850 849 871 875 872 +73 1 872 874 873 885 889 886 +74 1 886 888 887 904 908 905 +75 1 905 907 906 915 919 916 +76 1 916 918 917 927 931 928 +77 1 928 930 929 948 952 949 +78 2 933 936 934 935 943 937 +79 2 933 935 934 936 944 938 +80 2 934 943 935 937 945 939 +81 2 934 944 936 938 946 939 +82 2 935 945 937 939 940 938 +83 2 936 946 938 939 940 937 +84 1 949 951 950 962 966 963 +85 1 954 956 955 957 961 960 +86 1 963 965 964 981 985 982 +87 1 982 984 983 998 1002 999 +88 1 988 990 989 991 997 996 +89 1 999 1001 1000 1020 1024 1021 +90 1 1021 1023 1022 1035 1039 1036 +91 1 1036 1038 1037 1046 1050 1047 +92 1 1047 1049 1048 1060 1064 1061 +93 1 1061 1063 1062 1079 1083 1080 +94 1 1080 1082 1081 1097 1101 1098 +95 4 1085 1088 1086 1087 1093 1089 +96 5 1085 1087 1086 1088 1094 1090 +97 6 1086 1093 1087 1089 1095 1090 +98 4 1086 1094 1088 1090 1096 1089 +99 6 1087 1095 1089 1090 1096 1088 +100 1 1098 1100 1099 1116 1120 1117 +101 1 1117 1119 1118 1132 1136 1133 +102 1 1133 1135 1134 1151 1155 1152 +103 1 1152 1154 1153 1175 1179 1176 +104 1 1176 1178 1177 1194 1198 1195 +105 1 1195 1197 1196 1218 1222 1219 +106 1 1219 1221 1220 1225 1229 1226 PiTorsion Coeffs diff --git a/tools/tinker/tinker2lmp.py b/tools/tinker/tinker2lmp.py index 3d871747b6..27376af0cf 100644 --- a/tools/tinker/tinker2lmp.py +++ b/tools/tinker/tinker2lmp.py @@ -755,7 +755,8 @@ for atom1 in id: atom5 = bonds[atom2-1][0] atom6 = bonds[atom2-1][1] - pitorsionlist.append((atom3,atom4,atom1,atom2,atom5,atom6)) + #pitorsionlist.append((atom3,atom4,atom1,atom2,atom5,atom6)) + pitorsionlist.append((atom3,atom4,atom1,atom2,atom6,atom5)) # create bitorslist = list of 5-body interactions # generate topology via double loop over neighbors of central atom3 From 240056f5a67d04ffcdb9bbfcb86b0216337d3b9f Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Wed, 20 Apr 2022 09:43:14 -0600 Subject: [PATCH 140/585] tweak to README --- examples/amoeba/README | 4 +--- 1 file changed, 1 insertion(+), 3 deletions(-) diff --git a/examples/amoeba/README b/examples/amoeba/README index 57138357eb..7207593c47 100644 --- a/examples/amoeba/README +++ b/examples/amoeba/README @@ -20,6 +20,4 @@ Data files in this directory were created by the tools/tinker/tinker2lmp.py scri ** ubiquitin: -% python tinker2lmp.py -xyz ubiquitin.xyz -amoeba amoeba_ubiquitin.prm -data data.ubiquitin.new -pbc 54.99 41.91 41.91 -bitorsion bitorsion.ubiquitin.data.new - - +% python tinker2lmp.py -xyz ubiquitin.xyz -amoeba amoeba_ubiquitin.prm -data data.ubiquitin -pbc 54.99 41.91 41.91 -bitorsion bitorsion.ubiquitin.data From af1851a6bbd84163fe629a73b74cb921214e1970 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Wed, 20 Apr 2022 11:45:55 -0600 Subject: [PATCH 141/585] sign flip on pitorsion forces --- src/AMOEBA/fix_amoeba_pitorsion.cpp | 36 ++++++++++++++--------------- 1 file changed, 18 insertions(+), 18 deletions(-) diff --git a/src/AMOEBA/fix_amoeba_pitorsion.cpp b/src/AMOEBA/fix_amoeba_pitorsion.cpp index 369c191963..19ec7e6786 100644 --- a/src/AMOEBA/fix_amoeba_pitorsion.cpp +++ b/src/AMOEBA/fix_amoeba_pitorsion.cpp @@ -501,44 +501,44 @@ void FixAmoebaPiTorsion::post_force(int vflag) if (ia < nlocal) { epitorsion += engfraction; - f[ia][0] -= dedxia; - f[ia][1] -= dedyia; - f[ia][2] -= dedzia; + f[ia][0] += dedxia; + f[ia][1] += dedyia; + f[ia][2] += dedzia; } if (ib < nlocal) { epitorsion += engfraction; - f[ib][0] -= dedxib; - f[ib][1] -= dedyib; - f[ib][2] -= dedzib; + f[ib][0] += dedxib; + f[ib][1] += dedyib; + f[ib][2] += dedzib; } if (ic < nlocal) { epitorsion += engfraction; - f[ic][0] -= dedxic; - f[ic][1] -= dedyic; - f[ic][2] -= dedzic; + f[ic][0] += dedxic; + f[ic][1] += dedyic; + f[ic][2] += dedzic; } if (id < nlocal) { epitorsion += engfraction; - f[id][0] -= dedxid; - f[id][1] -= dedyid; - f[id][2] -= dedzid; + f[id][0] += dedxid; + f[id][1] += dedyid; + f[id][2] += dedzid; } if (ie < nlocal) { epitorsion += engfraction; - f[ie][0] -= dedxie; - f[ie][1] -= dedyie; - f[ie][2] -= dedzie; + f[ie][0] += dedxie; + f[ie][1] += dedyie; + f[ie][2] += dedzie; } if (ig < nlocal) { epitorsion += engfraction; - f[ig][0] -= dedxig; - f[ig][1] -= dedyig; - f[ig][2] -= dedzig; + f[ig][0] += dedxig; + f[ig][1] += dedyig; + f[ig][2] += dedzig; } // virial tensor components From f52e40772beeaf107c316a3377b416198a16f711 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Wed, 20 Apr 2022 14:16:11 -0600 Subject: [PATCH 142/585] bitorsion for ubi --- examples/amoeba/in.ubiquitin | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/examples/amoeba/in.ubiquitin b/examples/amoeba/in.ubiquitin index ef6f55c6da..e8516dc09c 100644 --- a/examples/amoeba/in.ubiquitin +++ b/examples/amoeba/in.ubiquitin @@ -29,7 +29,7 @@ read_data data.ubiquitin fix amtype NULL "Tinker Types" & fix pit pitorsions PiTorsions & fix bit bitorsions BiTorsions -pair_style amoeba +pair_style amoeba include bitorsion pair_coeff * * amoeba_ubiquitin.prm amoeba_ubiquitin.key special_bonds lj/coul 0.5 0.5 0.5 one/five yes From 04ac4c469551fe3e173e4021a9344e51297f69e1 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Wed, 20 Apr 2022 16:55:56 -0600 Subject: [PATCH 143/585] debug info for bitorsions --- src/AMOEBA/fix_amoeba_bitorsion.cpp | 68 ++++++++++++++++++++++++----- 1 file changed, 56 insertions(+), 12 deletions(-) diff --git a/src/AMOEBA/fix_amoeba_bitorsion.cpp b/src/AMOEBA/fix_amoeba_bitorsion.cpp index 55841a4f5b..a6f522c430 100644 --- a/src/AMOEBA/fix_amoeba_bitorsion.cpp +++ b/src/AMOEBA/fix_amoeba_bitorsion.cpp @@ -392,6 +392,14 @@ void FixAmoebaBiTorsion::post_force(int vflag) ie = bitorsion_list[n][4]; btype = bitorsion_list[n][5]; + if (n == 0) + printf("BITORSION: abcde %d %d %d %d %d\n", + atom->tag[ia], + atom->tag[ib], + atom->tag[ic], + atom->tag[id], + atom->tag[ie]); + xia = x[ia][0]; yia = x[ia][1]; zia = x[ia][2]; @@ -455,12 +463,19 @@ void FixAmoebaBiTorsion::post_force(int vflag) if (sign < 0.0) angle2 = -angle2; value2 = angle2; + if (n == 0) + printf(" angle1 %g angle2 %g value1 %g value2 %g\n", + angle1,angle2,value1,value2); + // check for inverted chirality at the central atom // inputs = ib,ic,id // outputs = sign,value1,value2 chkttor(ib,ic,id,sign,value1,value2); + if (n == 0) + printf(" post-chktor: value1 %g value2 %g\n",value1,value2); + // 2 binary searches to find location of angles 1,2 in grid // ttx,tty are 0-indexed here, 1-indexed in Tinker // xlo,ylo = final location, each one less than in Tinker @@ -487,6 +502,9 @@ void FixAmoebaBiTorsion::post_force(int vflag) } ylo = nlo; + if (n == 0) + printf(" xlo/ylo: %d %d\n",xlo,ylo); + // fill ftt,ft1,ft2,ft12 vecs with spline coeffs near xlo,ylo grid pt // ttx,tty,tbf,tbx,tby,tbxy are 0-indexed here, 1-indexed in Tinker // xlo,ylo,pos1,pos2 are all one less than in Tinker @@ -519,31 +537,33 @@ void FixAmoebaBiTorsion::post_force(int vflag) ft12[2] = tbxy[btype][pos2+1]; ft12[3] = tbxy[btype][pos2]; + if (n == 0) + printf(" pre-bcuint1 x1l %g xlu %g y1l %g y1u %g pos12 %d %d\n", + x1l,x1u,y1l,y1u,pos1,pos2); + // bicuint1() uses bicubic interpolation to compute interpolated values // outputs = e,dedang1,dedang2 + if (n == 0) { + printf(" ftt %g %g %g %g\n",ftt[0],ftt[1],ftt[2],ftt[3]); + printf(" ft1 %g %g %g %g\n",ft1[0],ft1[1],ft1[2],ft1[3]); + printf(" ft2 %g %g %g %g\n",ft2[0],ft2[1],ft2[2],ft2[3]); + printf(" ft12 %g %g %g %g\n",ft12[0],ft12[1],ft12[2],ft12[3]); + } + bcuint1(ftt,ft1,ft2,ft12,x1l,x1u,y1l,y1u,value1,value2, e,dedang1,dedang2); dedang1 = sign * radian2degree * dedang1; dedang2 = sign * radian2degree * dedang2; - // DEBUG - - /* - printf("BiTorsion: %d %d %d %d %d: angle12 %g %g: eng %g\n", - atom->tag[ia], - atom->tag[ib], - atom->tag[ic], - atom->tag[id], - atom->tag[ie], - angle1,angle2,e); - */ - // fraction of energy for each atom engfraction = e * onefifth; + if (n == 0) + printf(" post-bcuint1 dedang12 %g %g eng %g\n",dedang1,dedang2,e); + // chain rule terms for first angle derivative components xca = xic - xia; @@ -605,6 +625,9 @@ void FixAmoebaBiTorsion::post_force(int vflag) // increment the torsion-torsion energy and gradient + if (n == 0) + printf(" forceA dedia %g %g %g\n",dedxia,dedyia,dedzia); + if (ia < nlocal) { ebitorsion += engfraction; f[ia][0] -= dedxia; @@ -612,6 +635,12 @@ void FixAmoebaBiTorsion::post_force(int vflag) f[ia][2] -= dedzia; } + if (n == 0) + printf(" forceB dedib %g %g %g\n", + dedxib+dedxib2, + dedyib+dedyib2, + dedzib+dedzib2); + if (ib < nlocal) { ebitorsion += engfraction; f[ib][0] -= dedxib + dedxib2; @@ -619,6 +648,12 @@ void FixAmoebaBiTorsion::post_force(int vflag) f[ib][2] -= dedzib + dedzib2; } + if (n == 0) + printf(" forceC dedic %g %g %g\n", + dedxic+dedxic2, + dedyic+dedyic2, + dedzic+dedzic2); + if (ic < nlocal) { ebitorsion += engfraction; f[ic][0] -= dedxic + dedxic2; @@ -626,6 +661,12 @@ void FixAmoebaBiTorsion::post_force(int vflag) f[ic][2] -= dedzic + dedzic2; } + if (n == 0) + printf(" forceD dedid %g %g %g\n", + dedxid+dedxid2, + dedyid+dedyid2, + dedzid+dedzid2); + if (id < nlocal) { ebitorsion += engfraction; f[id][0] -= dedxid + dedxid2; @@ -633,6 +674,9 @@ void FixAmoebaBiTorsion::post_force(int vflag) f[id][2] -= dedzid + dedzid2; } + if (n == 0) + printf(" forceE dedie %g %g %g\n",dedxie2,dedyie2,dedzie2); + if (ie < nlocal) { ebitorsion += engfraction; f[ie][0] -= dedxie2; From 501ef071c5279a0c9c57ab989c38f017ca56c5aa Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Thu, 21 Apr 2022 10:06:53 -0600 Subject: [PATCH 144/585] revert to original pitorsion code --- examples/amoeba/data.ubiquitin | 212 ++++++++++++++-------------- examples/amoeba/in.ubiquitin | 2 +- src/AMOEBA/fix_amoeba_pitorsion.cpp | 2 +- tools/tinker/tinker2lmp.py | 3 +- 4 files changed, 109 insertions(+), 110 deletions(-) diff --git a/examples/amoeba/data.ubiquitin b/examples/amoeba/data.ubiquitin index 653cbc3639..aada520e6d 100644 --- a/examples/amoeba/data.ubiquitin +++ b/examples/amoeba/data.ubiquitin @@ -26425,112 +26425,112 @@ BiTorsions PiTorsions -1 1 2 4 3 20 24 21 -2 1 21 23 22 37 41 38 -3 1 27 29 28 30 36 35 -4 1 38 40 39 56 60 57 -5 1 57 59 58 76 80 77 -6 2 62 65 63 64 71 66 -7 2 62 64 63 65 72 67 -8 2 63 71 64 66 73 68 -9 2 63 72 65 67 74 68 -10 2 64 73 66 68 75 67 -11 2 65 74 67 68 75 66 -12 1 77 79 78 92 96 93 -13 1 93 95 94 114 118 115 -14 1 115 117 116 128 132 129 -15 1 129 131 130 147 151 148 -16 1 148 150 149 161 165 162 -17 1 162 164 163 168 172 169 -18 1 169 171 170 190 194 191 -19 1 191 193 192 204 208 205 -20 1 205 207 206 223 227 224 -21 1 224 226 225 237 241 238 -22 1 238 240 239 256 260 257 -23 1 257 259 258 271 275 272 -24 1 272 274 273 287 291 288 -25 3 288 290 289 302 309 303 -26 1 303 305 304 316 320 317 -27 1 317 319 318 327 331 328 -28 1 328 330 329 339 343 340 -29 1 340 342 341 353 357 354 -30 1 354 356 355 372 376 373 -31 1 373 375 374 387 391 388 -32 1 388 390 389 401 405 402 -33 1 393 395 394 396 400 399 -34 1 402 404 403 417 421 418 -35 1 418 420 419 439 443 440 -36 1 440 442 441 449 453 450 -37 1 450 452 451 471 475 472 -38 1 472 474 473 490 494 491 -39 1 491 493 492 507 511 508 -40 1 497 499 498 500 506 505 -41 1 508 510 509 519 523 520 -42 1 520 522 521 541 545 542 -43 1 542 544 543 556 560 557 -44 1 557 559 558 563 567 564 -45 3 564 566 565 582 589 583 -46 3 583 585 584 596 603 597 -47 1 597 599 598 610 614 611 -48 1 611 613 612 622 626 623 -49 1 623 625 624 639 643 640 -50 1 629 631 630 632 638 637 -51 1 640 642 641 656 660 657 -52 1 646 648 647 649 655 654 -53 1 657 659 658 680 684 681 -54 1 681 683 682 699 703 700 -55 1 700 702 701 718 722 719 -56 1 719 721 720 738 742 739 -57 2 724 727 725 726 733 728 -58 2 724 726 725 727 734 729 -59 2 725 733 726 728 735 730 -60 2 725 734 727 729 736 730 -61 2 726 735 728 730 737 729 -62 2 727 736 729 730 737 728 -63 1 739 741 740 748 752 749 -64 1 749 751 750 755 759 756 -65 1 756 758 757 777 781 778 -66 1 778 780 779 794 798 795 -67 1 784 786 785 787 793 792 -68 1 795 797 796 813 817 814 -69 1 814 816 815 828 832 829 -70 1 829 831 830 840 844 841 -71 1 841 843 842 847 851 848 -72 1 848 850 849 871 875 872 -73 1 872 874 873 885 889 886 -74 1 886 888 887 904 908 905 -75 1 905 907 906 915 919 916 -76 1 916 918 917 927 931 928 -77 1 928 930 929 948 952 949 -78 2 933 936 934 935 943 937 -79 2 933 935 934 936 944 938 -80 2 934 943 935 937 945 939 -81 2 934 944 936 938 946 939 -82 2 935 945 937 939 940 938 -83 2 936 946 938 939 940 937 -84 1 949 951 950 962 966 963 -85 1 954 956 955 957 961 960 -86 1 963 965 964 981 985 982 -87 1 982 984 983 998 1002 999 -88 1 988 990 989 991 997 996 -89 1 999 1001 1000 1020 1024 1021 -90 1 1021 1023 1022 1035 1039 1036 -91 1 1036 1038 1037 1046 1050 1047 -92 1 1047 1049 1048 1060 1064 1061 -93 1 1061 1063 1062 1079 1083 1080 -94 1 1080 1082 1081 1097 1101 1098 -95 4 1085 1088 1086 1087 1093 1089 -96 5 1085 1087 1086 1088 1094 1090 -97 6 1086 1093 1087 1089 1095 1090 -98 4 1086 1094 1088 1090 1096 1089 -99 6 1087 1095 1089 1090 1096 1088 -100 1 1098 1100 1099 1116 1120 1117 -101 1 1117 1119 1118 1132 1136 1133 -102 1 1133 1135 1134 1151 1155 1152 -103 1 1152 1154 1153 1175 1179 1176 -104 1 1176 1178 1177 1194 1198 1195 -105 1 1195 1197 1196 1218 1222 1219 -106 1 1219 1221 1220 1225 1229 1226 +1 1 2 4 3 20 21 24 +2 1 21 23 22 37 38 41 +3 1 27 29 28 30 35 36 +4 1 38 40 39 56 57 60 +5 1 57 59 58 76 77 80 +6 2 62 65 63 64 66 71 +7 2 62 64 63 65 67 72 +8 2 63 71 64 66 68 73 +9 2 63 72 65 67 68 74 +10 2 64 73 66 68 67 75 +11 2 65 74 67 68 66 75 +12 1 77 79 78 92 93 96 +13 1 93 95 94 114 115 118 +14 1 115 117 116 128 129 132 +15 1 129 131 130 147 148 151 +16 1 148 150 149 161 162 165 +17 1 162 164 163 168 169 172 +18 1 169 171 170 190 191 194 +19 1 191 193 192 204 205 208 +20 1 205 207 206 223 224 227 +21 1 224 226 225 237 238 241 +22 1 238 240 239 256 257 260 +23 1 257 259 258 271 272 275 +24 1 272 274 273 287 288 291 +25 3 288 290 289 302 303 309 +26 1 303 305 304 316 317 320 +27 1 317 319 318 327 328 331 +28 1 328 330 329 339 340 343 +29 1 340 342 341 353 354 357 +30 1 354 356 355 372 373 376 +31 1 373 375 374 387 388 391 +32 1 388 390 389 401 402 405 +33 1 393 395 394 396 399 400 +34 1 402 404 403 417 418 421 +35 1 418 420 419 439 440 443 +36 1 440 442 441 449 450 453 +37 1 450 452 451 471 472 475 +38 1 472 474 473 490 491 494 +39 1 491 493 492 507 508 511 +40 1 497 499 498 500 505 506 +41 1 508 510 509 519 520 523 +42 1 520 522 521 541 542 545 +43 1 542 544 543 556 557 560 +44 1 557 559 558 563 564 567 +45 3 564 566 565 582 583 589 +46 3 583 585 584 596 597 603 +47 1 597 599 598 610 611 614 +48 1 611 613 612 622 623 626 +49 1 623 625 624 639 640 643 +50 1 629 631 630 632 637 638 +51 1 640 642 641 656 657 660 +52 1 646 648 647 649 654 655 +53 1 657 659 658 680 681 684 +54 1 681 683 682 699 700 703 +55 1 700 702 701 718 719 722 +56 1 719 721 720 738 739 742 +57 2 724 727 725 726 728 733 +58 2 724 726 725 727 729 734 +59 2 725 733 726 728 730 735 +60 2 725 734 727 729 730 736 +61 2 726 735 728 730 729 737 +62 2 727 736 729 730 728 737 +63 1 739 741 740 748 749 752 +64 1 749 751 750 755 756 759 +65 1 756 758 757 777 778 781 +66 1 778 780 779 794 795 798 +67 1 784 786 785 787 792 793 +68 1 795 797 796 813 814 817 +69 1 814 816 815 828 829 832 +70 1 829 831 830 840 841 844 +71 1 841 843 842 847 848 851 +72 1 848 850 849 871 872 875 +73 1 872 874 873 885 886 889 +74 1 886 888 887 904 905 908 +75 1 905 907 906 915 916 919 +76 1 916 918 917 927 928 931 +77 1 928 930 929 948 949 952 +78 2 933 936 934 935 937 943 +79 2 933 935 934 936 938 944 +80 2 934 943 935 937 939 945 +81 2 934 944 936 938 939 946 +82 2 935 945 937 939 938 940 +83 2 936 946 938 939 937 940 +84 1 949 951 950 962 963 966 +85 1 954 956 955 957 960 961 +86 1 963 965 964 981 982 985 +87 1 982 984 983 998 999 1002 +88 1 988 990 989 991 996 997 +89 1 999 1001 1000 1020 1021 1024 +90 1 1021 1023 1022 1035 1036 1039 +91 1 1036 1038 1037 1046 1047 1050 +92 1 1047 1049 1048 1060 1061 1064 +93 1 1061 1063 1062 1079 1080 1083 +94 1 1080 1082 1081 1097 1098 1101 +95 4 1085 1088 1086 1087 1089 1093 +96 5 1085 1087 1086 1088 1090 1094 +97 6 1086 1093 1087 1089 1090 1095 +98 4 1086 1094 1088 1090 1089 1096 +99 6 1087 1095 1089 1090 1088 1096 +100 1 1098 1100 1099 1116 1117 1120 +101 1 1117 1119 1118 1132 1133 1136 +102 1 1133 1135 1134 1151 1152 1155 +103 1 1152 1154 1153 1175 1176 1179 +104 1 1176 1178 1177 1194 1195 1198 +105 1 1195 1197 1196 1218 1219 1222 +106 1 1219 1221 1220 1225 1226 1229 PiTorsion Coeffs diff --git a/examples/amoeba/in.ubiquitin b/examples/amoeba/in.ubiquitin index e8516dc09c..cbae525bc1 100644 --- a/examples/amoeba/in.ubiquitin +++ b/examples/amoeba/in.ubiquitin @@ -29,7 +29,7 @@ read_data data.ubiquitin fix amtype NULL "Tinker Types" & fix pit pitorsions PiTorsions & fix bit bitorsions BiTorsions -pair_style amoeba include bitorsion +pair_style amoeba include pitorsion pair_coeff * * amoeba_ubiquitin.prm amoeba_ubiquitin.key special_bonds lj/coul 0.5 0.5 0.5 one/five yes diff --git a/src/AMOEBA/fix_amoeba_pitorsion.cpp b/src/AMOEBA/fix_amoeba_pitorsion.cpp index 19ec7e6786..014059661f 100644 --- a/src/AMOEBA/fix_amoeba_pitorsion.cpp +++ b/src/AMOEBA/fix_amoeba_pitorsion.cpp @@ -350,7 +350,7 @@ void FixAmoebaPiTorsion::post_force(int vflag) ic = pitorsion_list[n][2]; id = pitorsion_list[n][3]; ie = pitorsion_list[n][4]; - ig = pitorsion_list[n][5]; + ib = pitorsion_list[n][5]; ptype = pitorsion_list[n][6]; // compute the value of the pi-system torsion angle diff --git a/tools/tinker/tinker2lmp.py b/tools/tinker/tinker2lmp.py index 27376af0cf..3d871747b6 100644 --- a/tools/tinker/tinker2lmp.py +++ b/tools/tinker/tinker2lmp.py @@ -755,8 +755,7 @@ for atom1 in id: atom5 = bonds[atom2-1][0] atom6 = bonds[atom2-1][1] - #pitorsionlist.append((atom3,atom4,atom1,atom2,atom5,atom6)) - pitorsionlist.append((atom3,atom4,atom1,atom2,atom6,atom5)) + pitorsionlist.append((atom3,atom4,atom1,atom2,atom5,atom6)) # create bitorslist = list of 5-body interactions # generate topology via double loop over neighbors of central atom3 From 1d12069daf1d0b771dde38ee7d2430e9f5760425 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Fri, 22 Apr 2022 13:18:30 -0600 Subject: [PATCH 145/585] fix typo in index --- src/AMOEBA/fix_amoeba_pitorsion.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/AMOEBA/fix_amoeba_pitorsion.cpp b/src/AMOEBA/fix_amoeba_pitorsion.cpp index 014059661f..19ec7e6786 100644 --- a/src/AMOEBA/fix_amoeba_pitorsion.cpp +++ b/src/AMOEBA/fix_amoeba_pitorsion.cpp @@ -350,7 +350,7 @@ void FixAmoebaPiTorsion::post_force(int vflag) ic = pitorsion_list[n][2]; id = pitorsion_list[n][3]; ie = pitorsion_list[n][4]; - ib = pitorsion_list[n][5]; + ig = pitorsion_list[n][5]; ptype = pitorsion_list[n][6]; // compute the value of the pi-system torsion angle From a88efcbbda6e5b9c6858dea36235cf0ed5511dcb Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Fri, 22 Apr 2022 13:50:48 -0600 Subject: [PATCH 146/585] sign flip in pitorsion --- src/AMOEBA/fix_amoeba_pitorsion.cpp | 36 ++++++++++++++--------------- 1 file changed, 18 insertions(+), 18 deletions(-) diff --git a/src/AMOEBA/fix_amoeba_pitorsion.cpp b/src/AMOEBA/fix_amoeba_pitorsion.cpp index 19ec7e6786..369c191963 100644 --- a/src/AMOEBA/fix_amoeba_pitorsion.cpp +++ b/src/AMOEBA/fix_amoeba_pitorsion.cpp @@ -501,44 +501,44 @@ void FixAmoebaPiTorsion::post_force(int vflag) if (ia < nlocal) { epitorsion += engfraction; - f[ia][0] += dedxia; - f[ia][1] += dedyia; - f[ia][2] += dedzia; + f[ia][0] -= dedxia; + f[ia][1] -= dedyia; + f[ia][2] -= dedzia; } if (ib < nlocal) { epitorsion += engfraction; - f[ib][0] += dedxib; - f[ib][1] += dedyib; - f[ib][2] += dedzib; + f[ib][0] -= dedxib; + f[ib][1] -= dedyib; + f[ib][2] -= dedzib; } if (ic < nlocal) { epitorsion += engfraction; - f[ic][0] += dedxic; - f[ic][1] += dedyic; - f[ic][2] += dedzic; + f[ic][0] -= dedxic; + f[ic][1] -= dedyic; + f[ic][2] -= dedzic; } if (id < nlocal) { epitorsion += engfraction; - f[id][0] += dedxid; - f[id][1] += dedyid; - f[id][2] += dedzid; + f[id][0] -= dedxid; + f[id][1] -= dedyid; + f[id][2] -= dedzid; } if (ie < nlocal) { epitorsion += engfraction; - f[ie][0] += dedxie; - f[ie][1] += dedyie; - f[ie][2] += dedzie; + f[ie][0] -= dedxie; + f[ie][1] -= dedyie; + f[ie][2] -= dedzie; } if (ig < nlocal) { epitorsion += engfraction; - f[ig][0] += dedxig; - f[ig][1] += dedyig; - f[ig][2] += dedzig; + f[ig][0] -= dedxig; + f[ig][1] -= dedyig; + f[ig][2] -= dedzig; } // virial tensor components From e43730bd74113dd3e3545d99c5199b811425ee64 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Fri, 22 Apr 2022 15:30:16 -0600 Subject: [PATCH 147/585] add chkttor method to bitorsions --- examples/amoeba/in.ubiquitin | 2 +- src/AMOEBA/fix_amoeba_bitorsion.cpp | 129 ++++++++++++++++++++++++---- src/AMOEBA/fix_amoeba_bitorsion.h | 5 ++ src/AMOEBA/pair_amoeba.cpp | 4 + 4 files changed, 124 insertions(+), 16 deletions(-) diff --git a/examples/amoeba/in.ubiquitin b/examples/amoeba/in.ubiquitin index cbae525bc1..e8516dc09c 100644 --- a/examples/amoeba/in.ubiquitin +++ b/examples/amoeba/in.ubiquitin @@ -29,7 +29,7 @@ read_data data.ubiquitin fix amtype NULL "Tinker Types" & fix pit pitorsions PiTorsions & fix bit bitorsions BiTorsions -pair_style amoeba include pitorsion +pair_style amoeba include bitorsion pair_coeff * * amoeba_ubiquitin.prm amoeba_ubiquitin.key special_bonds lj/coul 0.5 0.5 0.5 one/five yes diff --git a/src/AMOEBA/fix_amoeba_bitorsion.cpp b/src/AMOEBA/fix_amoeba_bitorsion.cpp index a6f522c430..8714d263d4 100644 --- a/src/AMOEBA/fix_amoeba_bitorsion.cpp +++ b/src/AMOEBA/fix_amoeba_bitorsion.cpp @@ -185,18 +185,20 @@ void FixAmoebaBiTorsion::init() if (respa_level >= 0) ilevel_respa = MIN(respa_level,ilevel_respa); } - // check if PairAmoeba or PairHippo disabled bitorsion terms + // error check that PairAmoeba or PairHiippo exist - Pair *pair = NULL; + pair = nullptr; pair = force->pair_match("amoeba",1,0); if (!pair) pair = force->pair_match("hippo",1,0); - if (!pair) disable = 0; - else { - int tmp; - int flag = *((int *) pair->extract("bitorsion_flag",tmp)); - disable = flag ? 0 : 1; - } + if (!pair) + error->all(FLERR,"Cannot use fix amoeba/bitorsion w/out pair amoeba/hippo"); + + // check if PairAmoeba or PairHippo disabled bitorsion terms + + int tmp; + int flag = *((int *) pair->extract("bitorsion_flag",tmp)); + disable = flag ? 0 : 1; // constant @@ -324,7 +326,7 @@ void FixAmoebaBiTorsion::post_force(int vflag) int nx,ny,nlo,nhi,nt; int xlo,ylo; int pos1,pos2; - double e,fgrp,sign; + double e,fgrp,sign,dot; double angle1,angle2; double value1,value2; double cosine1,cosine2; @@ -377,11 +379,19 @@ void FixAmoebaBiTorsion::post_force(int vflag) int eflag = eflag_caller; ev_init(eflag,vflag); + // set current ptrs to PairAmoeba amtype and atomic_num + + int tmp; + amtype = (int *) pair->extract("amtype",tmp); + atomic_num = (int *) pair->extract("atomic_num",tmp); + + // loop over local bitorsions + double **x = atom->x; double **f = atom->f; int nlocal = atom->nlocal; - //printf("Nbitorsions %d\n",nbitorsion_list); + printf("Nbitorsions %d\n",nbitorsion_list); for (int n = 0; n < nbitorsion_list; n++) { @@ -451,16 +461,16 @@ void FixAmoebaBiTorsion::post_force(int vflag) cosine1 = (xt*xu + yt*yu + zt*zu) / rtru; cosine1 = MIN(1.0,MAX(-1.0,cosine1)); angle1 = radian2degree * acos(cosine1); - sign = xba*xu + yba*yu + zba*zu; - if (sign < 0.0) angle1 = -angle1; + dot = xba*xu + yba*yu + zba*zu; + if (dot < 0.0) angle1 = -angle1; value1 = angle1; rdc = sqrt(xdc*xdc + ydc*ydc + zdc*zdc); cosine2 = (xu*xv + yu*yv + zu*zv) / rurv; cosine2 = MIN(1.0,MAX(-1.0,cosine2)); angle2 = radian2degree * acos(cosine2); - sign = xcb*xv + ycb*yv + zcb*zv; - if (sign < 0.0) angle2 = -angle2; + dot = xcb*xv + ycb*yv + zcb*zv; + if (dot < 0.0) angle2 = -angle2; value2 = angle2; if (n == 0) @@ -562,7 +572,8 @@ void FixAmoebaBiTorsion::post_force(int vflag) engfraction = e * onefifth; if (n == 0) - printf(" post-bcuint1 dedang12 %g %g eng %g\n",dedang1,dedang2,e); + printf(" post-bcuint1 sign %g dedang12 %g %g eng %g\n", + sign,dedang1,dedang2,e); // chain rule terms for first angle derivative components @@ -1275,11 +1286,85 @@ void FixAmoebaBiTorsion::cytsys(int n, double *dm, double *du, } /* ---------------------------------------------------------------------- + chkttor tests the attached atoms at a torsion-torsion central + site and inverts the angle values if the site is chiral ------------------------------------------------------------------------- */ void FixAmoebaBiTorsion::chkttor(int ib, int ic, int id, double &sign, double &value1, double &value2) { + int i,ia,ilocal,jlocal,klocal,jtype,ktype; + tagint j,k,m; + double xac,yac,zac; + double xbc,ybc,zbc; + double xdc,ydc,zdc; + double c1,c2,c3,vol; + + // test for chirality at the central torsion-torsion site + + sign = 1.0; + if (atom->nspecial[ic][0] != 4) return; + + tagint **special = atom->special; + tagint *tag = atom->tag; + + // j,k,m are atom IDs + + j = 0; + for (i = 0; i < 4; i++) { + m = special[ic][i]; + if (m != tag[ib] && m != tag[id]) { + if (j == 0) j = m; + else k = m; + } + } + + // convert atom IDs j,k to local indices jlocal,klocal closest to atom IC + + jlocal = atom->map(j); + jlocal = domain->closest_image(ic,jlocal); + jtype = amtype[jlocal]; + + klocal = atom->map(k); + klocal = domain->closest_image(ic,klocal); + ktype = amtype[klocal]; + + // atom ilocal = jlocal or klocal (or -1) + // set atom IA = ilocal + + ilocal = -1; + if (jtype > ktype) ilocal = jlocal; + if (ktype > jtype) ilocal = klocal; + if (atomic_num[jtype] > atomic_num[ktype]) ilocal = jlocal; + if (atomic_num[ktype] > atomic_num[jtype]) ilocal = klocal; + if (ilocal < 0) return; + ia = ilocal; + + // compute the signed parallelpiped volume at central site + + double **x = atom->x; + + xac = x[ia][0] - x[ic][0]; + yac = x[ia][1] - x[ic][1]; + zac = x[ia][2] - x[ic][2]; + xbc = x[ib][0] - x[ic][0]; + ybc = x[ib][1] - x[ic][1]; + zbc = x[ib][2] - x[ic][2]; + xdc = x[id][0] - x[ic][0]; + ydc = x[id][1] - x[ic][1]; + zdc = x[id][2] - x[ic][2]; + c1 = ybc*zdc - zbc*ydc; + c2 = ydc*zac - zdc*yac; + c3 = yac*zbc - zac*ybc; + vol = xac*c1 + xbc*c2 + xdc*c3; + + // invert the angle values if chirality has an inverted sign + + if (vol < 0.0) { + sign = -1.0; + value1 = -value1; + value2 = -value2; + } } /* ---------------------------------------------------------------------- @@ -1301,6 +1386,9 @@ void FixAmoebaBiTorsion::bcuint1(double *y, double *y1, bcucof(y,y1,y2,y12,x1u-x1l,x2u-x2l,c); + //printf(" bcuint1: c[1][1] %g c[4][1] %g c[1][4] %g c[4][4] %g\n", + // c[0][0],c[3][0],c[0][3],c[3][3]); + double t = (x1-x1l) / (x1u-x1l); double u = (x2-x2l) / (x2u-x2l); @@ -1314,6 +1402,8 @@ void FixAmoebaBiTorsion::bcuint1(double *y, double *y1, ansy1 /= x1u-x1l; ansy2 /= x2u-x2l; + + //printf(" bcuint1: t u %g %g ansy %g ansy12 %g %g\n",t,u,ansy,ansy1,ansy2); } /* ---------------------------------------------------------------------- @@ -1340,6 +1430,12 @@ void FixAmoebaBiTorsion::bcucof(double *y, double *y1, double *y2, double *y12, x[i+12] = y12[i] * d1d2; } + //printf(" bcucof: x[1] %g x[5] %g x[9] %g x[13] %g\n", + // x[0],x[4],x[8],x[12]); + + //printf(" bcucof: WT[3][1] %g WT[16][2] %g WT[7][5] %g\n", + // WT[2][0],WT[15][1],WT[6][4]); + // matrix multiply by the stored weight table for (i = 0; i < 16; i++) { @@ -1349,6 +1445,9 @@ void FixAmoebaBiTorsion::bcucof(double *y, double *y1, double *y2, double *y12, cl[i] = xx; } + //printf(" bcucof: cl[1] %g cl[5] %g cl[9] %g cl[13] %g\n", + // cl[0],cl[4],cl[8],cl[12]); + // unpack the result into the coefficient table j = 0; diff --git a/src/AMOEBA/fix_amoeba_bitorsion.h b/src/AMOEBA/fix_amoeba_bitorsion.h index 49a7b5b7ec..c27fa8e547 100644 --- a/src/AMOEBA/fix_amoeba_bitorsion.h +++ b/src/AMOEBA/fix_amoeba_bitorsion.h @@ -97,6 +97,11 @@ class FixAmoebaBiTorsion : public Fix { double **ttx,**tty,**tbf; double **tbx,**tby,**tbxy; + // data from PairAmoeba + + class Pair *pair; + int *amtype,*atomic_num; + // local methods void read_grid_data(char *); diff --git a/src/AMOEBA/pair_amoeba.cpp b/src/AMOEBA/pair_amoeba.cpp index 6869aa57e4..0c9f6f8b6e 100644 --- a/src/AMOEBA/pair_amoeba.cpp +++ b/src/AMOEBA/pair_amoeba.cpp @@ -2078,6 +2078,10 @@ void PairAmoeba::mix() void *PairAmoeba::extract(const char *str, int &dim) { dim = 0; + + if (strcmp(str,"amtype") == 0) return (void *) amtype; + if (strcmp(str,"atomic_num") == 0) return (void *) atomic_num; + if (strcmp(str,"bond_flag") == 0) return (void *) &bond_flag; if (strcmp(str,"angle_flag") == 0) return (void *) &angle_flag; if (strcmp(str,"dihedral_flag") == 0) return (void *) &dihedral_flag; From f7cdfdd884499cba6ce4a762edc5908b12f74028 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Fri, 22 Apr 2022 16:03:48 -0600 Subject: [PATCH 148/585] remove debug in bitorsion --- examples/amoeba/in.ubiquitin | 4 +- src/AMOEBA/fix_amoeba_bitorsion.cpp | 73 ----------------------------- 2 files changed, 2 insertions(+), 75 deletions(-) diff --git a/examples/amoeba/in.ubiquitin b/examples/amoeba/in.ubiquitin index e8516dc09c..09df9aa5df 100644 --- a/examples/amoeba/in.ubiquitin +++ b/examples/amoeba/in.ubiquitin @@ -29,7 +29,7 @@ read_data data.ubiquitin fix amtype NULL "Tinker Types" & fix pit pitorsions PiTorsions & fix bit bitorsions BiTorsions -pair_style amoeba include bitorsion +pair_style amoeba pair_coeff * * amoeba_ubiquitin.prm amoeba_ubiquitin.key special_bonds lj/coul 0.5 0.5 0.5 one/five yes @@ -50,5 +50,5 @@ run 0 #fix 1 all nve -#thermo 1 +#thermo 10 #run 100 diff --git a/src/AMOEBA/fix_amoeba_bitorsion.cpp b/src/AMOEBA/fix_amoeba_bitorsion.cpp index 8714d263d4..762a84ae2e 100644 --- a/src/AMOEBA/fix_amoeba_bitorsion.cpp +++ b/src/AMOEBA/fix_amoeba_bitorsion.cpp @@ -391,8 +391,6 @@ void FixAmoebaBiTorsion::post_force(int vflag) double **f = atom->f; int nlocal = atom->nlocal; - printf("Nbitorsions %d\n",nbitorsion_list); - for (int n = 0; n < nbitorsion_list; n++) { ia = bitorsion_list[n][0]; @@ -402,14 +400,6 @@ void FixAmoebaBiTorsion::post_force(int vflag) ie = bitorsion_list[n][4]; btype = bitorsion_list[n][5]; - if (n == 0) - printf("BITORSION: abcde %d %d %d %d %d\n", - atom->tag[ia], - atom->tag[ib], - atom->tag[ic], - atom->tag[id], - atom->tag[ie]); - xia = x[ia][0]; yia = x[ia][1]; zia = x[ia][2]; @@ -473,19 +463,12 @@ void FixAmoebaBiTorsion::post_force(int vflag) if (dot < 0.0) angle2 = -angle2; value2 = angle2; - if (n == 0) - printf(" angle1 %g angle2 %g value1 %g value2 %g\n", - angle1,angle2,value1,value2); - // check for inverted chirality at the central atom // inputs = ib,ic,id // outputs = sign,value1,value2 chkttor(ib,ic,id,sign,value1,value2); - if (n == 0) - printf(" post-chktor: value1 %g value2 %g\n",value1,value2); - // 2 binary searches to find location of angles 1,2 in grid // ttx,tty are 0-indexed here, 1-indexed in Tinker // xlo,ylo = final location, each one less than in Tinker @@ -512,9 +495,6 @@ void FixAmoebaBiTorsion::post_force(int vflag) } ylo = nlo; - if (n == 0) - printf(" xlo/ylo: %d %d\n",xlo,ylo); - // fill ftt,ft1,ft2,ft12 vecs with spline coeffs near xlo,ylo grid pt // ttx,tty,tbf,tbx,tby,tbxy are 0-indexed here, 1-indexed in Tinker // xlo,ylo,pos1,pos2 are all one less than in Tinker @@ -547,20 +527,9 @@ void FixAmoebaBiTorsion::post_force(int vflag) ft12[2] = tbxy[btype][pos2+1]; ft12[3] = tbxy[btype][pos2]; - if (n == 0) - printf(" pre-bcuint1 x1l %g xlu %g y1l %g y1u %g pos12 %d %d\n", - x1l,x1u,y1l,y1u,pos1,pos2); - // bicuint1() uses bicubic interpolation to compute interpolated values // outputs = e,dedang1,dedang2 - if (n == 0) { - printf(" ftt %g %g %g %g\n",ftt[0],ftt[1],ftt[2],ftt[3]); - printf(" ft1 %g %g %g %g\n",ft1[0],ft1[1],ft1[2],ft1[3]); - printf(" ft2 %g %g %g %g\n",ft2[0],ft2[1],ft2[2],ft2[3]); - printf(" ft12 %g %g %g %g\n",ft12[0],ft12[1],ft12[2],ft12[3]); - } - bcuint1(ftt,ft1,ft2,ft12,x1l,x1u,y1l,y1u,value1,value2, e,dedang1,dedang2); @@ -571,10 +540,6 @@ void FixAmoebaBiTorsion::post_force(int vflag) engfraction = e * onefifth; - if (n == 0) - printf(" post-bcuint1 sign %g dedang12 %g %g eng %g\n", - sign,dedang1,dedang2,e); - // chain rule terms for first angle derivative components xca = xic - xia; @@ -636,9 +601,6 @@ void FixAmoebaBiTorsion::post_force(int vflag) // increment the torsion-torsion energy and gradient - if (n == 0) - printf(" forceA dedia %g %g %g\n",dedxia,dedyia,dedzia); - if (ia < nlocal) { ebitorsion += engfraction; f[ia][0] -= dedxia; @@ -646,12 +608,6 @@ void FixAmoebaBiTorsion::post_force(int vflag) f[ia][2] -= dedzia; } - if (n == 0) - printf(" forceB dedib %g %g %g\n", - dedxib+dedxib2, - dedyib+dedyib2, - dedzib+dedzib2); - if (ib < nlocal) { ebitorsion += engfraction; f[ib][0] -= dedxib + dedxib2; @@ -659,12 +615,6 @@ void FixAmoebaBiTorsion::post_force(int vflag) f[ib][2] -= dedzib + dedzib2; } - if (n == 0) - printf(" forceC dedic %g %g %g\n", - dedxic+dedxic2, - dedyic+dedyic2, - dedzic+dedzic2); - if (ic < nlocal) { ebitorsion += engfraction; f[ic][0] -= dedxic + dedxic2; @@ -672,12 +622,6 @@ void FixAmoebaBiTorsion::post_force(int vflag) f[ic][2] -= dedzic + dedzic2; } - if (n == 0) - printf(" forceD dedid %g %g %g\n", - dedxid+dedxid2, - dedyid+dedyid2, - dedzid+dedzid2); - if (id < nlocal) { ebitorsion += engfraction; f[id][0] -= dedxid + dedxid2; @@ -685,9 +629,6 @@ void FixAmoebaBiTorsion::post_force(int vflag) f[id][2] -= dedzid + dedzid2; } - if (n == 0) - printf(" forceE dedie %g %g %g\n",dedxie2,dedyie2,dedzie2); - if (ie < nlocal) { ebitorsion += engfraction; f[ie][0] -= dedxie2; @@ -1386,9 +1327,6 @@ void FixAmoebaBiTorsion::bcuint1(double *y, double *y1, bcucof(y,y1,y2,y12,x1u-x1l,x2u-x2l,c); - //printf(" bcuint1: c[1][1] %g c[4][1] %g c[1][4] %g c[4][4] %g\n", - // c[0][0],c[3][0],c[0][3],c[3][3]); - double t = (x1-x1l) / (x1u-x1l); double u = (x2-x2l) / (x2u-x2l); @@ -1402,8 +1340,6 @@ void FixAmoebaBiTorsion::bcuint1(double *y, double *y1, ansy1 /= x1u-x1l; ansy2 /= x2u-x2l; - - //printf(" bcuint1: t u %g %g ansy %g ansy12 %g %g\n",t,u,ansy,ansy1,ansy2); } /* ---------------------------------------------------------------------- @@ -1430,12 +1366,6 @@ void FixAmoebaBiTorsion::bcucof(double *y, double *y1, double *y2, double *y12, x[i+12] = y12[i] * d1d2; } - //printf(" bcucof: x[1] %g x[5] %g x[9] %g x[13] %g\n", - // x[0],x[4],x[8],x[12]); - - //printf(" bcucof: WT[3][1] %g WT[16][2] %g WT[7][5] %g\n", - // WT[2][0],WT[15][1],WT[6][4]); - // matrix multiply by the stored weight table for (i = 0; i < 16; i++) { @@ -1445,9 +1375,6 @@ void FixAmoebaBiTorsion::bcucof(double *y, double *y1, double *y2, double *y12, cl[i] = xx; } - //printf(" bcucof: cl[1] %g cl[5] %g cl[9] %g cl[13] %g\n", - // cl[0],cl[4],cl[8],cl[12]); - // unpack the result into the coefficient table j = 0; From 78aec491ff871ca2135b3861cd34f40b80ab89ca Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Fri, 22 Apr 2022 17:32:26 -0600 Subject: [PATCH 149/585] Minor tweaks --- examples/snap/grid.local.py | 8 +++++--- 1 file changed, 5 insertions(+), 3 deletions(-) diff --git a/examples/snap/grid.local.py b/examples/snap/grid.local.py index 8b8cb99d66..414558b79b 100755 --- a/examples/snap/grid.local.py +++ b/examples/snap/grid.local.py @@ -82,9 +82,11 @@ bgridlocalnrows = lmp.extract_compute("bgridlocal", LMP_STYLE_LOCAL, LMP_SIZE_RO print("bgridlocal nrows = ",bgridlocalnrows) bgridlocalncols = lmp.extract_compute("bgridlocal", LMP_STYLE_LOCAL, LMP_SIZE_COLS) print("bgridlocal ncols = ",bgridlocalncols) -bgridlocalptr = lmp.extract_compute("bgridlocal", LMP_STYLE_LOCAL, LMP_TYPE_ARRAY) -print("bgridlocal = ",bgridlocalptr) -print("bgridlocal[0][0] = ",bgridlocalptr[5][10]) + +if bgridlocalnrows > 0: + bgridlocalptr = lmp.extract_compute("bgridlocal", LMP_STYLE_LOCAL, LMP_TYPE_ARRAY) + print("bgridlocal = ",bgridlocalptr) + print("bgridlocal[0][0] = ",bgridlocalptr[5][10]) # print out the LAMMPS array to a file From 221142a36d38bda6504b7eda906da37b152ace07 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Thu, 28 Apr 2022 17:12:01 -0600 Subject: [PATCH 150/585] sign flips for virial terms --- src/AMOEBA/amoeba_charge_transfer.cpp | 12 ++--- src/AMOEBA/amoeba_dispersion.cpp | 18 +++---- src/AMOEBA/amoeba_hal.cpp | 12 ++--- src/AMOEBA/amoeba_multipole.cpp | 38 +++++++------- src/AMOEBA/amoeba_polar.cpp | 72 +++++++++++++-------------- src/AMOEBA/amoeba_repulsion.cpp | 24 ++++----- src/AMOEBA/angle_amoeba.cpp | 8 ++- src/AMOEBA/fix_amoeba_pitorsion.cpp | 12 ++--- src/AMOEBA/improper_amoeba.cpp | 6 ++- 9 files changed, 105 insertions(+), 97 deletions(-) diff --git a/src/AMOEBA/amoeba_charge_transfer.cpp b/src/AMOEBA/amoeba_charge_transfer.cpp index 1d395e9924..3ab5171d93 100644 --- a/src/AMOEBA/amoeba_charge_transfer.cpp +++ b/src/AMOEBA/amoeba_charge_transfer.cpp @@ -155,12 +155,12 @@ void PairAmoeba::charge_transfer() vyz = zr * frcy; vzz = zr * frcz; - virqxfer[0] += vxx; - virqxfer[1] += vyy; - virqxfer[2] += vzz; - virqxfer[3] += vxy; - virqxfer[4] += vxz; - virqxfer[5] += vyz; + virqxfer[0] -= vxx; + virqxfer[1] -= vyy; + virqxfer[2] -= vzz; + virqxfer[3] -= vxy; + virqxfer[4] -= vxz; + virqxfer[5] -= vyz; // energy = e // virial = 6-vec vir diff --git a/src/AMOEBA/amoeba_dispersion.cpp b/src/AMOEBA/amoeba_dispersion.cpp index a3cd114ae4..1969a3bf33 100644 --- a/src/AMOEBA/amoeba_dispersion.cpp +++ b/src/AMOEBA/amoeba_dispersion.cpp @@ -219,12 +219,12 @@ void PairAmoeba::dispersion_real() vzy = zr * dedy; vzz = zr * dedz; - virdisp[0] += vxx; - virdisp[1] += vyy; - virdisp[2] += vzz; - virdisp[3] += vyx; - virdisp[4] += vzx; - virdisp[5] += vzy; + virdisp[0] -= vxx; + virdisp[1] -= vyy; + virdisp[2] -= vzz; + virdisp[3] -= vyx; + virdisp[4] -= vzx; + virdisp[5] -= vzy; // energy = e // virial = 6-vec vir @@ -418,8 +418,8 @@ void PairAmoeba::dispersion_kspace() if (me == 0) { edisp -= term; - virdisp[0] += term; - virdisp[1] += term; - virdisp[2] += term; + virdisp[0] -= term; + virdisp[1] -= term; + virdisp[2] -= term; } } diff --git a/src/AMOEBA/amoeba_hal.cpp b/src/AMOEBA/amoeba_hal.cpp index 01123251e7..561a2869a2 100644 --- a/src/AMOEBA/amoeba_hal.cpp +++ b/src/AMOEBA/amoeba_hal.cpp @@ -195,12 +195,12 @@ void PairAmoeba::hal() vzy = zr * dedy; vzz = zr * dedz; - virhal[0] += vxx; - virhal[1] += vyy; - virhal[2] += vzz; - virhal[3] += vyx; - virhal[4] += vzx; - virhal[5] += vzy; + virhal[0] -= vxx; + virhal[1] -= vyy; + virhal[2] -= vzz; + virhal[3] -= vyx; + virhal[4] -= vzx; + virhal[5] -= vzy; // energy = e // virial = 6-vec vir diff --git a/src/AMOEBA/amoeba_multipole.cpp b/src/AMOEBA/amoeba_multipole.cpp index 5f66f41deb..3e19f89233 100644 --- a/src/AMOEBA/amoeba_multipole.cpp +++ b/src/AMOEBA/amoeba_multipole.cpp @@ -533,12 +533,12 @@ void PairAmoeba::multipole_real() vyz = -0.5 * (zr*frcy+yr*frcz); vzz = -zr * frcz; - virmpole[0] += vxx; - virmpole[1] += vyy; - virmpole[2] += vzz; - virmpole[3] += vxy; - virmpole[4] += vxz; - virmpole[5] += vyz; + virmpole[0] -= vxx; + virmpole[1] -= vyy; + virmpole[2] -= vzz; + virmpole[3] -= vxy; + virmpole[4] -= vxz; + virmpole[5] -= vyz; // energy = e // virial = 6-vec vir @@ -583,12 +583,12 @@ void PairAmoeba::multipole_real() yix*fix[2] + yiy*fiy[2] + yiz*fiz[2]); vzz = zix*fix[2] + ziy*fiy[2] + ziz*fiz[2]; - virmpole[0] += vxx; - virmpole[1] += vyy; - virmpole[2] += vzz; - virmpole[3] += vxy; - virmpole[4] += vxz; - virmpole[5] += vyz; + virmpole[0] -= vxx; + virmpole[1] -= vyy; + virmpole[2] -= vzz; + virmpole[3] -= vxy; + virmpole[4] -= vxz; + virmpole[5] -= vyz; } } @@ -781,7 +781,6 @@ void PairAmoeba::multipole_kspace() for (k = 0; k < 20; k++) fphi[i][k] *= felec; } - //printf("fphi elec %e %e %e %e \n",fphi[0][0],fphi[0][1],fphi[0][2],fphi[0][3]); // convert field from fractional to Cartesian @@ -811,7 +810,6 @@ void PairAmoeba::multipole_kspace() f[i][2] -= h3; } empole += 0.5*e; - //printf("mpole_force %g %g %g \n", f[0][0], f[0][1], f[0][2]); // augment the permanent multipole virial contributions @@ -878,12 +876,12 @@ void PairAmoeba::multipole_kspace() // increment total internal virial tensor components - virmpole[0] += vxx; - virmpole[1] += vyy; - virmpole[2] += vzz; - virmpole[3] += vxy; - virmpole[4] += vxz; - virmpole[5] += vyz; + virmpole[0] -= vxx; + virmpole[1] -= vyy; + virmpole[2] -= vzz; + virmpole[3] -= vxy; + virmpole[4] -= vxz; + virmpole[5] -= vyz; // free local memory diff --git a/src/AMOEBA/amoeba_polar.cpp b/src/AMOEBA/amoeba_polar.cpp index da84053f0d..d067fd5dc0 100644 --- a/src/AMOEBA/amoeba_polar.cpp +++ b/src/AMOEBA/amoeba_polar.cpp @@ -129,12 +129,12 @@ void PairAmoeba::polar() vyz = 0.5 * (zix*fix[1] + ziy*fiy[1] + ziz*fiz[1] + yix*fix[2] + yiy*fiy[2] + yiz*fiz[2]); - virpolar[0] += vxx; - virpolar[1] += vyy; - virpolar[2] += vzz; - virpolar[3] += vxy; - virpolar[4] += vxz; - virpolar[5] += vyz; + virpolar[0] -= vxx; + virpolar[1] -= vyy; + virpolar[2] -= vzz; + virpolar[3] -= vxy; + virpolar[4] -= vxz; + virpolar[5] -= vyz; } // clean up @@ -1155,12 +1155,12 @@ void PairAmoeba::polar_real() vyz = 0.5 * (zr*frcy+yr*frcz); vzz = zr * frcz; - virpolar[0] += vxx; - virpolar[1] += vyy; - virpolar[2] += vzz; - virpolar[3] += vxy; - virpolar[4] += vxz; - virpolar[5] += vyz; + virpolar[0] -= vxx; + virpolar[1] -= vyy; + virpolar[2] -= vzz; + virpolar[3] -= vxy; + virpolar[4] -= vxz; + virpolar[5] -= vyz; // energy = e // virial = 6-vec vir @@ -1224,12 +1224,12 @@ void PairAmoeba::polar_real() vyz = 0.5 * (zix*fix[1] + ziy*fiy[1] + ziz*fiz[1] + yix*fix[2] + yiy*fiy[2] + yiz*fiz[2]); - virpolar[0] += vxx; - virpolar[1] += vyy; - virpolar[2] += vzz; - virpolar[3] += vxy; - virpolar[4] += vxz; - virpolar[5] += vyz; + virpolar[0] -= vxx; + virpolar[1] -= vyy; + virpolar[2] -= vzz; + virpolar[3] -= vxy; + virpolar[4] -= vxz; + virpolar[5] -= vyz; } } @@ -2125,12 +2125,12 @@ void PairAmoeba::polar_kspace() qgrid[k3][k2][k1][1]*qgrip[k3][k2][k1][1]; eterm = 0.5 * felec * expterm * struc2; vterm = (2.0/hsq) * (1.0-term) * eterm; - virpolar[0] += h1*h1*vterm - eterm; - virpolar[1] += h2*h2*vterm - eterm; - virpolar[2] += h3*h3*vterm - eterm; - virpolar[3] += h1*h2*vterm; - virpolar[4] += h1*h3*vterm; - virpolar[5] += h2*h3*vterm; + virpolar[0] -= h1*h1*vterm - eterm; + virpolar[1] -= h2*h2*vterm - eterm; + virpolar[2] -= h3*h3*vterm - eterm; + virpolar[3] -= h1*h2*vterm; + virpolar[4] -= h1*h3*vterm; + virpolar[5] -= h2*h3*vterm; } } @@ -2189,12 +2189,12 @@ void PairAmoeba::polar_kspace() qgrid[k3][k2][k1][1]*qgrip[k3][k2][k1][1]; eterm = 0.5 * felec * expterm * struc2; vterm = (2.0/hsq) * (1.0-term) * eterm; - virpolar[0] += h1*h1*vterm - eterm; - virpolar[1] += h2*h2*vterm - eterm; - virpolar[2] += h3*h3*vterm - eterm; - virpolar[3] += h1*h2*vterm; - virpolar[4] += h1*h3*vterm; - virpolar[5] += h2*h3*vterm; + virpolar[0] -= h1*h1*vterm - eterm; + virpolar[1] -= h2*h2*vterm - eterm; + virpolar[2] -= h3*h3*vterm - eterm; + virpolar[3] -= h1*h2*vterm; + virpolar[4] -= h1*h3*vterm; + virpolar[5] -= h2*h3*vterm; } } } @@ -2203,12 +2203,12 @@ void PairAmoeba::polar_kspace() // increment the total internal virial tensor components - virpolar[0] += vxx; - virpolar[1] += vyy; - virpolar[2] += vzz; - virpolar[3] += vxy; - virpolar[4] += vxz; - virpolar[5] += vyz; + virpolar[0] -= vxx; + virpolar[1] -= vyy; + virpolar[2] -= vzz; + virpolar[3] -= vxy; + virpolar[4] -= vxz; + virpolar[5] -= vyz; // deallocation of local arrays, some from induce diff --git a/src/AMOEBA/amoeba_repulsion.cpp b/src/AMOEBA/amoeba_repulsion.cpp index a0694aeef4..c2bd490715 100644 --- a/src/AMOEBA/amoeba_repulsion.cpp +++ b/src/AMOEBA/amoeba_repulsion.cpp @@ -361,12 +361,12 @@ void PairAmoeba::repulsion() vyz = -0.5 * (zr*frcy+yr*frcz); vzz = -zr * frcz; - virrepulse[0] += vxx; - virrepulse[1] += vyy; - virrepulse[2] += vzz; - virrepulse[3] += vxy; - virrepulse[4] += vxz; - virrepulse[5] += vyz; + virrepulse[0] -= vxx; + virrepulse[1] -= vyy; + virrepulse[2] -= vzz; + virrepulse[3] -= vxy; + virrepulse[4] -= vxz; + virrepulse[5] -= vyz; // energy = e // virial = 6-vec vir @@ -414,12 +414,12 @@ void PairAmoeba::repulsion() vyz = 0.5 * (zix*fix[1] + ziy*fiy[1] + ziz*fiz[1] + yix*fix[2] + yiy*fiy[2] + yiz*fiz[2]); - virrepulse[0] += vxx; - virrepulse[1] += vyy; - virrepulse[2] += vzz; - virrepulse[3] += vxy; - virrepulse[4] += vxz; - virrepulse[5] += vyz; + virrepulse[0] -= vxx; + virrepulse[1] -= vyy; + virrepulse[2] -= vzz; + virrepulse[3] -= vxy; + virrepulse[4] -= vxz; + virrepulse[5] -= vyz; // virial = 6-vec vir // NOTE: add tally function diff --git a/src/AMOEBA/angle_amoeba.cpp b/src/AMOEBA/angle_amoeba.cpp index 98ee1953da..bb85783b6e 100644 --- a/src/AMOEBA/angle_amoeba.cpp +++ b/src/AMOEBA/angle_amoeba.cpp @@ -416,7 +416,13 @@ void AngleAmoeba::tinker_anglep(int i1, int i2, int i3, int type, int eflag) f[i4][2] -= f4[2]; } - if (evflag) ev_tally4(i1,i2,i3,14,nlocal,newton_bond,eangle,f1,f2,f3,f4); + if (evflag) { + f1[0] = -f1[0]; f1[1] = -f1[1]; f1[2] = -f1[2]; + f2[0] = -f2[0]; f2[1] = -f2[1]; f2[2] = -f2[2]; + f3[0] = -f3[0]; f3[1] = -f3[1]; f3[2] = -f3[2]; + f4[0] = -f4[0]; f4[1] = -f4[1]; f4[2] = -f4[2]; + ev_tally4(i1,i2,i3,14,nlocal,newton_bond,eangle,f1,f2,f3,f4); + } } /* ---------------------------------------------------------------------- */ diff --git a/src/AMOEBA/fix_amoeba_pitorsion.cpp b/src/AMOEBA/fix_amoeba_pitorsion.cpp index 369c191963..eb4223e43b 100644 --- a/src/AMOEBA/fix_amoeba_pitorsion.cpp +++ b/src/AMOEBA/fix_amoeba_pitorsion.cpp @@ -555,12 +555,12 @@ void FixAmoebaPiTorsion::post_force(int vflag) vxterm = dedxid + dedxia + dedxib; vyterm = dedyid + dedyia + dedyib; vzterm = dedzid + dedzia + dedzib; - v[0] = xdc*vxterm + xcp*dedxip - xqd*dedxiq; - v[1] = ydc*vyterm + ycp*dedyip - yqd*dedyiq; - v[2] = zdc*vzterm + zcp*dedzip - zqd*dedziq; - v[3] = ydc*vxterm + ycp*dedxip - yqd*dedxiq; - v[4] = zdc*vxterm + zcp*dedxip - zqd*dedxiq; - v[5] = zdc*vyterm + zcp*dedyip - zqd*dedyiq; + v[0] = -xdc*vxterm - xcp*dedxip + xqd*dedxiq; + v[1] = -ydc*vyterm - ycp*dedyip + yqd*dedyiq; + v[2] = -zdc*vzterm - zcp*dedzip + zqd*dedziq; + v[3] = -ydc*vxterm - ycp*dedxip + yqd*dedxiq; + v[4] = -zdc*vxterm - zcp*dedxip + zqd*dedxiq; + v[5] = -zdc*vyterm - zcp*dedyip + zqd*dedyiq; ev_tally(nlist,list,6.0,e,v); } diff --git a/src/AMOEBA/improper_amoeba.cpp b/src/AMOEBA/improper_amoeba.cpp index 63409dd1ab..c985386019 100644 --- a/src/AMOEBA/improper_amoeba.cpp +++ b/src/AMOEBA/improper_amoeba.cpp @@ -227,9 +227,13 @@ void ImproperAmoeba::compute(int eflag, int vflag) f[ic][2] -= fc[2]; } - if (evflag) + if (evflag) { + fd[0] = -fd[0]; fd[1] = -fd[1]; fd[2] = -fd[2]; + fa[0] = -fa[0]; fa[1] = -fa[1]; fa[2] = -fa[2]; + fc[0] = -fc[0]; fc[1] = -fc[1]; fc[2] = -fc[2]; ev_tally(id,ib,ia,ic,nlocal,newton_bond,e,fd,fa,fc, xdb,ydb,zdb,xab,yab,zab,xic-xia,yic-yia,zic-zia); + } } } From 171b1020250f829043bba82c057ae31c133ad720 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 19 Apr 2022 16:46:21 -0400 Subject: [PATCH 151/585] AMOEBA package has a "hard" dependency on KSPACE --- cmake/CMakeLists.txt | 1 + src/AMOEBA/Install.sh | 40 ++++++++++++++++++++++++++++++++++++++++ 2 files changed, 41 insertions(+) create mode 100644 src/AMOEBA/Install.sh diff --git a/cmake/CMakeLists.txt b/cmake/CMakeLists.txt index 0b57eae4f4..1eb7f5f60f 100644 --- a/cmake/CMakeLists.txt +++ b/cmake/CMakeLists.txt @@ -329,6 +329,7 @@ pkg_depends(MPIIO MPI) pkg_depends(ATC MANYBODY) pkg_depends(LATBOLTZ MPI) pkg_depends(SCAFACOS MPI) +pkg_depends(AMOEBA KSPACE) pkg_depends(DIELECTRIC KSPACE) pkg_depends(DIELECTRIC EXTRA-PAIR) pkg_depends(CG-DNA MOLECULE) diff --git a/src/AMOEBA/Install.sh b/src/AMOEBA/Install.sh new file mode 100644 index 0000000000..a4032d781e --- /dev/null +++ b/src/AMOEBA/Install.sh @@ -0,0 +1,40 @@ +# Install/unInstall package files in LAMMPS +# mode = 0/1/2 for uninstall/install/update + +mode=$1 + +# enforce using portable C locale +LC_ALL=C +export LC_ALL + +# arg1 = file, arg2 = file it depends on + +action () { + if (test $mode = 0) then + rm -f ../$1 + elif (! cmp -s $1 ../$1) then + if (test -z "$2" || test -e ../$2) then + cp $1 .. + if (test $mode = 2) then + echo " updating src/$1" + fi + fi + elif (test -n "$2") then + if (test ! -e ../$2) then + rm -f ../$1 + fi + fi +} + +# pair style amoeba calls KSPACE functions and requires FFT grid. + +if (test $1 = 1) then + if (test ! -e ../pppm.cpp) then + echo "Must install KSPACE package with AMOEBA package" + exit 1 + fi +fi + +for file in *.cpp *.h; do + action ${file} +done From 66f5cbb0702e5504b6d20318b18fec709b4ad387 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sat, 23 Apr 2022 14:56:33 -0400 Subject: [PATCH 152/585] fix more tagint pointer bugs --- src/AMOEBA/atom_vec_amoeba.h | 3 +-- 1 file changed, 1 insertion(+), 2 deletions(-) diff --git a/src/AMOEBA/atom_vec_amoeba.h b/src/AMOEBA/atom_vec_amoeba.h index 4de18f7261..f7b559c74e 100644 --- a/src/AMOEBA/atom_vec_amoeba.h +++ b/src/AMOEBA/atom_vec_amoeba.h @@ -38,8 +38,7 @@ class AtomVecAmoeba : public AtomVec { private: int *num_bond,*num_angle,*num_dihedral,*num_improper; int **bond_type,**angle_type,**dihedral_type,**improper_type; - int **nspecial; - int *nspecial15; + int **nspecial, *nspecial15; int any_bond_negative,any_angle_negative, any_dihedral_negative,any_improper_negative; From a2a6437575f01da0952ec55fb6ec544e6f0b7bad Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 19 Apr 2022 16:48:14 -0400 Subject: [PATCH 153/585] simplify creation and lookup of fix store instances --- src/AMOEBA/pair_amoeba.cpp | 82 ++++++++++++-------------------------- 1 file changed, 26 insertions(+), 56 deletions(-) diff --git a/src/AMOEBA/pair_amoeba.cpp b/src/AMOEBA/pair_amoeba.cpp index 0c9f6f8b6e..41b8dd5267 100644 --- a/src/AMOEBA/pair_amoeba.cpp +++ b/src/AMOEBA/pair_amoeba.cpp @@ -736,21 +736,14 @@ void PairAmoeba::init_style() // create a new fix STORE style for each atom's pole vector // id = "AMOEBA_pole", fix group = all - if (first_flag) { - int n = strlen("AMOEBA_pole") + 1; - id_pole = new char[n]; - strcpy(id_pole,"AMOEBA_pole"); + // TODO: shouldn't there be an instance_me added to the identifier + // in case there would be multiple pair style instances in a hybrid pair style? - char **newarg = new char*[6]; - newarg[0] = id_pole; - newarg[1] = group->names[0]; - newarg[2] = (char *) "STORE"; - newarg[3] = (char *) "peratom"; - newarg[4] = (char *) "1"; - newarg[5] = (char *) "13"; - modify->add_fix(6,newarg); - fixpole = (FixStore *) modify->fix[modify->nfix-1]; - delete [] newarg; + Fix *myfix; + if (first_flag) { + id_pole = utils::strdup("AMOEBA_pole"); + myfix = modify->add_fix(fmt::format("{} {} STORE peratom 1 13",id_pole,group->names[0])); + fixpole = dynamic_cast(myfix); } // creation of per-atom storage @@ -760,40 +753,15 @@ void PairAmoeba::init_style() // only if using preconditioner if (first_flag && use_pred) { - char ualt[8]; - sprintf(ualt,"%d",maxualt); + id_udalt = utils::strdup("AMOEBA_udalt"); + myfix = modify->add_fix(fmt::format("{} {} STORE peratom 1 {} 3", + id_udalt, group->names[0], maxualt)); + fixudalt = dynamic_cast(myfix); - int n = strlen("AMOEBA_udalt") + 1; - id_udalt = new char[n]; - strcpy(id_udalt,"AMOEBA_udalt"); - - char **newarg = new char*[7]; - newarg[0] = id_udalt; - newarg[1] = group->names[0]; - newarg[2] = (char *) "STORE"; - newarg[3] = (char *) "peratom"; - newarg[4] = (char *) "1"; - newarg[5] = ualt; - newarg[6] = (char *) "3"; - modify->add_fix(7,newarg); - fixudalt = (FixStore *) modify->fix[modify->nfix-1]; - delete [] newarg; - - n = strlen("AMOEBA_upalt") + 1; - id_upalt = new char[n]; - strcpy(id_udalt,"AMOEBA_upalt"); - - newarg = new char*[7]; - newarg[0] = id_upalt; - newarg[1] = group->names[0]; - newarg[2] = (char *) "STORE"; - newarg[3] = (char *) "peratom"; - newarg[4] = (char *) "1"; - newarg[5] = ualt; - newarg[6] = (char *) "3"; - modify->add_fix(7,newarg); - fixupalt = (FixStore *) modify->fix[modify->nfix-1]; - delete [] newarg; + id_upalt = utils::strdup("AMOEBA_upalt"); + myfix = modify->add_fix(fmt::format("{} {} STORE peratom 1 {} 3", + id_upalt, group->names[0], maxualt)); + fixupalt = dynamic_cast(myfix); } // create pages for storing pairwise data: @@ -904,18 +872,20 @@ void PairAmoeba::init_style() // check for fixes which store persistent per-atom properties if (id_pole) { - int ifix = modify->find_fix(id_pole); - if (ifix < 0) error->all(FLERR,"Could not find pair amoeba fix ID"); - fixpole = (FixStore *) modify->fix[ifix]; + myfix = modify->get_fix_by_id(id_pole); + if (!myfix) error->all(FLERR,"Could not find internal pair amoeba fix STORE id {}", id_pole); + fixpole = dynamic_cast(myfix); + } if (id_udalt) { - int ifix = modify->find_fix(id_udalt); - if (ifix < 0) error->all(FLERR,"Could not find pair amoeba fix ID"); - fixudalt = (FixStore *) modify->fix[ifix]; - ifix = modify->find_fix(id_upalt); - if (ifix < 0) error->all(FLERR,"Could not find pair amoeba fix ID"); - fixupalt = (FixStore *) modify->fix[ifix]; + myfix = modify->get_fix_by_id(id_udalt); + if (!myfix) error->all(FLERR,"Could not find internal pair amoeba fix STORE id {}", id_udalt); + fixudalt = dynamic_cast(myfix); + + myfix = modify->get_fix_by_id(id_upalt); + if (!myfix) error->all(FLERR,"Could not find internal pair amoeba fix STORE id {}", id_upalt); + fixupalt = dynamic_cast(myfix); } // assign hydrogen neighbors (redID) to each owned atom From 723bf202c051bc4ba70d8136cf29c79bcfab6e96 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 19 Apr 2022 16:48:28 -0400 Subject: [PATCH 154/585] make use of utils::logmesg() and fmt::format --- src/AMOEBA/pair_amoeba.cpp | 172 ++++++++++++++++--------------------- src/AMOEBA/pair_amoeba.h | 2 +- 2 files changed, 75 insertions(+), 99 deletions(-) diff --git a/src/AMOEBA/pair_amoeba.cpp b/src/AMOEBA/pair_amoeba.cpp index 41b8dd5267..f8a0ceff70 100644 --- a/src/AMOEBA/pair_amoeba.cpp +++ b/src/AMOEBA/pair_amoeba.cpp @@ -156,9 +156,9 @@ PairAmoeba::~PairAmoeba() if (id_upalt) modify->delete_fix(id_upalt); } - delete [] id_pole; - delete [] id_udalt; - delete [] id_upalt; + delete[] id_pole; + delete[] id_udalt; + delete[] id_upalt; memory->destroy(xaxis2local); memory->destroy(yaxis2local); @@ -218,14 +218,14 @@ PairAmoeba::~PairAmoeba() if (amoeba) deallocate_vdwl(); deallocate_smallsize(); - delete [] forcefield; + delete[] forcefield; if (allocated) { memory->destroy(setflag); memory->destroy(cutsq); } - delete [] factors; + delete[] factors; // DEBUG @@ -475,32 +475,24 @@ void PairAmoeba::compute(int eflag, int vflag) MPI_Allreduce(&time_qxfer,&ave,1,MPI_DOUBLE,MPI_SUM,world); time_qxfer = ave/nprocs; - double time_amtot = time_init + time_hal + time_repulse + time_disp + - time_mpole + time_induce + time_polar + time_qxfer; + const double time_amtot = (time_init + time_hal + time_repulse + time_disp + + time_mpole + time_induce + time_polar + time_qxfer) / 100.0; if (me == 0) { utils::logmesg(lmp,"\nAMEOBA/HIPPO timing info:\n"); - utils::logmesg(lmp," Init time: {:.6g} {:.6g}\n", - time_init,time_init/time_amtot); - if (amoeba) - utils::logmesg(lmp," Hal time: {:.6g} {:.6g}\n", - time_hal,time_hal/time_amtot*100); + utils::logmesg(lmp," Init time: {:.6g} {:.3g}%\n", time_init, time_init/time_amtot); + if (amoeba) { + utils::logmesg(lmp," Hal time: {:.6g} {:.3g}%\n", time_hal, time_hal/time_amtot); + } else { // hippo + utils::logmesg(lmp," Repls time: {:.6g} {:.3g}%\n", time_repulse, time_repulse/time_amtot); + utils::logmesg(lmp," Disp time: {:.6g} {:.3g}%\n", time_disp, time_disp/time_amtot); + } + utils::logmesg(lmp," Mpole time: {:.6g} {:.3g}%\n", time_mpole, time_mpole/time_amtot); + utils::logmesg(lmp," Induce time: {:.6g} {:.3g}%\n", time_induce, time_induce/time_amtot); + utils::logmesg(lmp," Polar time: {:.6g} {:.3g}%\n", time_polar,time_polar/time_amtot); if (hippo) - utils::logmesg(lmp," Repls time: {:.6g} {:.6g}\n", - time_repulse,time_repulse/time_amtot*100); - if (hippo) - utils::logmesg(lmp," Disp time: {:.6g} {:.6g}\n", - time_disp,time_disp/time_amtot*100); - utils::logmesg(lmp," Mpole time: {:.6g} {:.6g}\n", - time_mpole,time_mpole/time_amtot*100); - utils::logmesg(lmp," Induce time: {:.6g} {:.6g}\n", - time_induce,time_induce/time_amtot*100); - utils::logmesg(lmp," Polar time: {:.6g} {:.6g}\n", - time_polar,time_polar/time_amtot*100); - if (hippo) - utils::logmesg(lmp," Qxfer time: {:.6g} {:.6g}\n", - time_qxfer,time_qxfer/time_amtot*100); - utils::logmesg(lmp," Total time: {:.6g}\n\n",time_amtot); + utils::logmesg(lmp," Qxfer time: {:.6g} {:.6g}%\n", time_qxfer, time_qxfer/time_amtot); + utils::logmesg(lmp," Total time: {:.6g}\n\n",time_amtot*100.0); } } @@ -686,7 +678,7 @@ void PairAmoeba::init_style() // error checks if (!atom->q_flag) - error->all(FLERR,"Pair style amoeba/hippo requires atom attribute q"); + error->all(FLERR,"Pair style {} requires atom attribute q", (amoeba) ? "amoeba" : "hippo"); //if (!force->special_onefive) // error->all(FLERR,"Pair style amoeba/hippo requires special_bonds one/five be set"); @@ -854,12 +846,7 @@ void PairAmoeba::init_style() // output FF settings to screen and logfile - if (first_flag) { - if (comm->me == 0) { - if (screen) print_settings(screen); - if (logfile) print_settings(logfile); - } - } + if (first_flag && (comm->me == 0)) print_settings(); // all done with one-time initializations @@ -940,99 +927,93 @@ void PairAmoeba::init_style() // open debug output files // names are hard-coded - if (me == 0) { - char fname[32]; - sprintf(fname,"tmp.uind.kspace.%d",nprocs); - if (UIND_DEBUG) fp_uind = fopen(fname,"w"); - } + if ((me == 0) && UIND_DEBUG) + fp_uind = fopen(fmt::format("tmp.uind.kspace.{}",nprocs).c_str(),"w"); } /* ---------------------------------------------------------------------- print settings to screen and logfile ------------------------------------------------------------------------- */ -void PairAmoeba::print_settings(FILE *fp) +void PairAmoeba::print_settings() { - fprintf(fp,"AMOEBA/HIPPO force field settings\n"); + std::string mesg = "AMOEBA/HIPPO force field settings\n"; if (amoeba) { choose(HAL); - fprintf(fp," hal: cut %g taper %g vscale %g %g %g %g\n", - sqrt(off2),sqrt(cut2), - special_hal[1],special_hal[2],special_hal[3],special_hal[4]); + mesg += fmt::format(" hal: cut {} taper {} vscale {} {} {} {}\n", + sqrt(off2),sqrt(cut2), + special_hal[1],special_hal[2],special_hal[3],special_hal[4]); } if (hippo) { choose(REPULSE); - fprintf(fp," repulsion: cut %g taper %g rscale %g %g %g %g\n", - sqrt(off2),sqrt(cut2), - special_repel[1],special_repel[2],special_repel[3],special_repel[4]); - } + mesg += fmt::format(" repulsion: cut {} taper {} rscale {} {} {} {}\n", + sqrt(off2),sqrt(cut2), + special_repel[1],special_repel[2],special_repel[3],special_repel[4]); - if (hippo) { choose(QFER); - fprintf(fp," qxfer: cut %g taper %g mscale %g %g %g %g\n", - sqrt(off2),sqrt(cut2), - special_mpole[1],special_mpole[2],special_mpole[3],special_mpole[4]); - } + mesg += fmt::format(" qxfer: cut {} taper {} mscale {} {} {} {}\n", + sqrt(off2),sqrt(cut2), + special_mpole[1],special_mpole[2],special_mpole[3],special_mpole[4]); - if (hippo) { if (use_dewald) { choose(DISP_LONG); - fprintf(fp," dispersion: cut %g aewald %g bsorder %d " - "FFT %d %d %d dspscale %g %g %g %g\n", - sqrt(off2),aewald,bsdorder,ndfft1,ndfft2,ndfft3, - special_disp[1],special_disp[2],special_disp[3],special_disp[4]); + mesg += fmt::format(" dispersion: cut {} aewald {} bsorder {} " + "FFT {} {} {} dspscale {} {} {} {}\n", + sqrt(off2),aewald,bsdorder,ndfft1,ndfft2,ndfft3, + special_disp[1],special_disp[2],special_disp[3],special_disp[4]); } else { choose(DISP); - fprintf(fp," dispersion: cut %g aewald %g dspscale %g %g %g %g\n", - sqrt(off2),aewald, - special_disp[1],special_disp[2],special_disp[3],special_disp[4]); + mesg += fmt::format(" dispersion: cut {} aewald {} dspscale {} {} {} {}\n", + sqrt(off2),aewald, + special_disp[1],special_disp[2],special_disp[3],special_disp[4]); } } if (use_ewald) { choose(MPOLE_LONG); - fprintf(fp," multipole: cut %g aewald %g bsorder %d " - "FFT %d %d %d mscale %g %g %g %g\n", - sqrt(off2),aewald,bseorder,nefft1,nefft2,nefft3, - special_mpole[1],special_mpole[2],special_mpole[3],special_mpole[4]); + mesg += fmt::format(" multipole: cut {} aewald {} bsorder {} " + "FFT {} {} {} mscale {} {} {} {}\n", + sqrt(off2),aewald,bseorder,nefft1,nefft2,nefft3, + special_mpole[1],special_mpole[2],special_mpole[3],special_mpole[4]); } else { choose(MPOLE); - fprintf(fp," multipole: cut %g aewald %g mscale %g %g %g %g\n", - sqrt(off2),aewald, - special_mpole[1],special_mpole[2],special_mpole[3],special_mpole[4]); + mesg += fmt::format(" multipole: cut {} aewald {} mscale {} {} {} {}\n", + sqrt(off2),aewald, + special_mpole[1],special_mpole[2],special_mpole[3],special_mpole[4]); } if (use_ewald) { choose(POLAR_LONG); - fprintf(fp," polar: cut %g aewald %g bsorder %d FFT %d %d %d\n", - sqrt(off2),aewald,bsporder,nefft1,nefft2,nefft3); - fprintf(fp," pscale %g %g %g %g piscale %g %g %g %g " - "wscale %g %g %g %g d/u scale %g %g\n", - special_polar_pscale[1],special_polar_pscale[2], - special_polar_pscale[3],special_polar_pscale[4], - special_polar_piscale[1],special_polar_piscale[2], - special_polar_piscale[3],special_polar_piscale[4], - special_polar_wscale[1],special_polar_wscale[2], - special_polar_wscale[3],special_polar_wscale[4], - polar_dscale,polar_uscale); + mesg += fmt::format(" polar: cut {} aewald {} bsorder {} FFT {} {} {}\n", + sqrt(off2),aewald,bsporder,nefft1,nefft2,nefft3); + mesg += fmt::format(" pscale {} {} {} {} piscale {} {} {} {} " + "wscale {} {} {} {} d/u scale {} {}\n", + special_polar_pscale[1],special_polar_pscale[2], + special_polar_pscale[3],special_polar_pscale[4], + special_polar_piscale[1],special_polar_piscale[2], + special_polar_piscale[3],special_polar_piscale[4], + special_polar_wscale[1],special_polar_wscale[2], + special_polar_wscale[3],special_polar_wscale[4], + polar_dscale,polar_uscale); } else { choose(POLAR); - fprintf(fp," polar: cut %g aewald %g\n",sqrt(off2),aewald); - fprintf(fp," pscale %g %g %g %g piscale %g %g %g %g " - "wscale %g %g %g %g d/u scale %g %g\n", - special_polar_pscale[1],special_polar_pscale[2], - special_polar_pscale[3],special_polar_pscale[4], - special_polar_piscale[1],special_polar_piscale[2], - special_polar_piscale[3],special_polar_piscale[4], - special_polar_wscale[1],special_polar_wscale[2], - special_polar_wscale[3],special_polar_wscale[4], - polar_dscale,polar_uscale); + mesg += fmt::format(" polar: cut {} aewald {}\n",sqrt(off2),aewald); + mesg += fmt::format(" pscale {} {} {} {} piscale {} {} {} {} " + "wscale {} {} {} {} d/u scale {} {}\n", + special_polar_pscale[1],special_polar_pscale[2], + special_polar_pscale[3],special_polar_pscale[4], + special_polar_piscale[1],special_polar_piscale[2], + special_polar_piscale[3],special_polar_piscale[4], + special_polar_wscale[1],special_polar_wscale[2], + special_polar_wscale[3],special_polar_wscale[4], + polar_dscale,polar_uscale); } choose(USOLV); - fprintf(fp," precondition: cut %g\n",sqrt(off2)); + mesg += fmt::format(" precondition: cut {}\n",sqrt(off2)); + utils::logmesg(lmp, mesg); } /* ---------------------------------------------------------------------- @@ -1678,12 +1659,7 @@ void PairAmoeba::assign_groups() bigint allbcount; MPI_Allreduce(&bcount,&allbcount,1,MPI_LMP_BIGINT,MPI_SUM,world); - if (comm->me == 0) { - if (screen) - fprintf(screen," AMOEBA/HIPPO group count: " BIGINT_FORMAT "\n",allbcount); - if (logfile) - fprintf(logfile," AMOEBA/HIPPO group count: " BIGINT_FORMAT "\n",allbcount); - } + if (comm->me == 0) utils::logmesg(lmp, " AMOEBA/HIPPO group count: {}\n",allbcount); } /* ---------------------------------------------------------------------- @@ -2232,9 +2208,9 @@ void PairAmoeba::dump6(FILE *fp, const char *columns, double scale, if (me == 0) { fprintf(fp,"ITEM: TIMESTEP\n"); - fprintf(fp,BIGINT_FORMAT "\n",update->ntimestep); + fmt::print(fp,"{}\n",update->ntimestep); fprintf(fp,"ITEM: NUMBER OF ATOMS\n"); - fprintf(fp,BIGINT_FORMAT "\n",atom->natoms); + fmt::print(fp,"{}\n",atom->natoms); fprintf(fp,"ITEM: BOX BOUNDS %s\n",boundstr); fprintf(fp,"%-1.16e %-1.16e\n",domain->boxlo[0],domain->boxhi[0]); fprintf(fp,"%-1.16e %-1.16e\n",domain->boxlo[1],domain->boxhi[1]); diff --git a/src/AMOEBA/pair_amoeba.h b/src/AMOEBA/pair_amoeba.h index 0057219b98..cd908ce534 100644 --- a/src/AMOEBA/pair_amoeba.h +++ b/src/AMOEBA/pair_amoeba.h @@ -405,7 +405,7 @@ class PairAmoeba : public Pair { // functions in pair_amoeba.cpp void allocate(); - void print_settings(FILE *); + void print_settings(); void initialize_vdwl(); void allocate_vdwl(); From c086c20238e6ecc6a6027c6750ca2da0f9b55dbe Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 28 Apr 2022 20:04:25 -0400 Subject: [PATCH 155/585] reduce compiler warnings. adapt LAMMPS programming style --- src/AMOEBA/amoeba_charge_transfer.cpp | 5 ----- src/AMOEBA/amoeba_dispersion.cpp | 24 ++++++++++++------------ src/AMOEBA/amoeba_file.cpp | 11 ++++------- src/AMOEBA/amoeba_hal.cpp | 12 +++--------- src/AMOEBA/amoeba_kspace.cpp | 12 ++---------- src/AMOEBA/amoeba_multipole.cpp | 18 ++++++------------ 6 files changed, 27 insertions(+), 55 deletions(-) diff --git a/src/AMOEBA/amoeba_charge_transfer.cpp b/src/AMOEBA/amoeba_charge_transfer.cpp index 3ab5171d93..7def2ec63d 100644 --- a/src/AMOEBA/amoeba_charge_transfer.cpp +++ b/src/AMOEBA/amoeba_charge_transfer.cpp @@ -29,18 +29,14 @@ enum{VDWL,REPULSE,QFER,DISP,MPOLE,POLAR,USOLV,DISP_LONG,MPOLE_LONG,POLAR_LONG}; void PairAmoeba::charge_transfer() { int i,j,ii,jj,itype,jtype,iclass,jclass; - int special_flag; double e,de,felec,fgrp; double rr1,r,r2; double r3,r4,r5; double xi,yi,zi; double xr,yr,zr; double chgi,chgj; - double chgij; double alphai,alphaj; - double alphaij; double expi,expj; - double expij; double frcx,frcy,frcz; double vxx,vyy,vzz; double vxy,vxz,vyz; @@ -58,7 +54,6 @@ void PairAmoeba::charge_transfer() double **x = atom->x; double **f = atom->f; - int nlocal = atom->nlocal; // neigh list diff --git a/src/AMOEBA/amoeba_dispersion.cpp b/src/AMOEBA/amoeba_dispersion.cpp index 1969a3bf33..e780b29402 100644 --- a/src/AMOEBA/amoeba_dispersion.cpp +++ b/src/AMOEBA/amoeba_dispersion.cpp @@ -12,18 +12,24 @@ ------------------------------------------------------------------------- */ #include "pair_amoeba.h" -#include + #include "amoeba_convolution.h" #include "atom.h" #include "domain.h" #include "neigh_list.h" #include "fft3d_wrap.h" #include "math_const.h" +#include "math_special.h" #include "memory.h" +#include + using namespace LAMMPS_NS; using namespace MathConst; +using MathSpecial::cube; +using MathSpecial::powint; + enum{VDWL,REPULSE,QFER,DISP,MPOLE,POLAR,USOLV,DISP_LONG,MPOLE_LONG,POLAR_LONG}; /* ---------------------------------------------------------------------- @@ -58,7 +64,7 @@ void PairAmoeba::dispersion() for (int i = 0; i < nlocal; i++) { itype = amtype[i]; iclass = amtype2class[itype]; - term = pow(aewald,6) / 12.0; + term = powint(aewald,6) / 12.0; edisp += term*csix[iclass]*csix[iclass]; } } @@ -73,7 +79,7 @@ void PairAmoeba::dispersion_real() int i,j,ii,jj,itype,jtype,iclass,jclass; double xi,yi,zi; double xr,yr,zr; - double e,de,fgrp; + double e,de; double ci,ck; double r,r2,r6,r7; double ai,ai2; @@ -100,7 +106,6 @@ void PairAmoeba::dispersion_real() double **x = atom->x; double **f = atom->f; - int nlocal = atom->nlocal; // neigh list @@ -193,7 +198,7 @@ void PairAmoeba::dispersion_real() scale = factor_disp * damp*damp; scale = scale - 1.0; e = -ci * ck * (expa+scale) / r6; - rterm = -pow(ralpha2,3) * expterm / r; + rterm = -cube(ralpha2) * expterm / r; de = -6.0*e/r2 - ci*ck*rterm/r7 - 2.0*ci*ck*factor_disp*damp*ddamp/r7; edisp += e; @@ -243,13 +248,9 @@ void PairAmoeba::dispersion_real() void PairAmoeba::dispersion_kspace() { - int i,j,k,m,n,ix,iy,iz,ib,jb,kb,itype,iclass; + int i,j,k,m,n,ib,jb,kb,itype,iclass; int nhalf1,nhalf2,nhalf3; int nxlo,nxhi,nylo,nyhi,nzlo,nzhi; - int i0,iatm,igrd0; - int it1,it2,it3; - int j0,jgrd0; - int k0,kgrd0; double e,fi,denom; double r1,r2,r3; double h1,h2,h3; @@ -270,7 +271,6 @@ void PairAmoeba::dispersion_kspace() // owned atoms - double **x = atom->x; double **f = atom->f; int nlocal = atom->nlocal; @@ -318,7 +318,7 @@ void PairAmoeba::dispersion_kspace() bfac = MY_PI / aewald; fac1 = 2.0*pow(MY_PI,3.5); - fac2 = pow(aewald,3.0); + fac2 = cube(aewald); fac3 = -2.0*aewald*MY_PI*MY_PI; denom0 = (6.0*volbox)/pow(MY_PI,1.5); diff --git a/src/AMOEBA/amoeba_file.cpp b/src/AMOEBA/amoeba_file.cpp index 34fe2f87a9..d5ce88d848 100644 --- a/src/AMOEBA/amoeba_file.cpp +++ b/src/AMOEBA/amoeba_file.cpp @@ -259,14 +259,11 @@ void PairAmoeba::read_keyfile(char *filename) int me = comm->me; FILE *fptr; - char line[MAXLINE],next[MAXLINE]; + char line[MAXLINE]; if (me == 0) { fptr = utils::open_potential(filename,lmp,nullptr); - if (fptr == NULL) { - char str[128]; - snprintf(str,128,"Cannot open AMOEBA key file %s",filename); - error->one(FLERR,str); - } + if (fptr == NULL) + error->one(FLERR,"Cannot open AMOEBA key file {}: {}",filename, utils::getsyserror()); } // read lines, one at a time @@ -597,7 +594,7 @@ int PairAmoeba::read_section_line(FILE *fp, char *line, char *ptr,*copy,*copy_next; char **words,**words_next; - int nwords,nwords_next; + int nwords_next; copy = copy_next = NULL; words = words_next = NULL; diff --git a/src/AMOEBA/amoeba_hal.cpp b/src/AMOEBA/amoeba_hal.cpp index 561a2869a2..c4beeb1fe3 100644 --- a/src/AMOEBA/amoeba_hal.cpp +++ b/src/AMOEBA/amoeba_hal.cpp @@ -30,17 +30,14 @@ void PairAmoeba::hal() { int i,j,ii,jj,itype,jtype,iclass,jclass,iv,jv; int special_which; - double e,de,eps,rdn; - double fgrp,rv,rv7; + double e,de,eps; + double rv,rv7; double xi,yi,zi; double xr,yr,zr; double redi,rediv; double redj,redjv; double dedx,dedy,dedz; - double rho,rho6,rho7; - double tau,tau7,scal; - double s1,s2,t1,t2; - double dt1drho,dt2drho; + double rho,tau,tau7; double dtau,gtau; double taper,dtaper; double rik,rik2,rik3; @@ -49,7 +46,6 @@ void PairAmoeba::hal() double vxx,vyy,vzz; double vyx,vzx,vzy; double factor_hal; - double vir[6]; int inum,jnum; int *ilist,*jlist,*numneigh,**firstneigh; @@ -60,9 +56,7 @@ void PairAmoeba::hal() // owned atoms - double **x = atom->x; double **f = atom->f; - int nlocal = atom->nlocal; // neigh list diff --git a/src/AMOEBA/amoeba_kspace.cpp b/src/AMOEBA/amoeba_kspace.cpp index 00ec415c4c..7349a1dff5 100644 --- a/src/AMOEBA/amoeba_kspace.cpp +++ b/src/AMOEBA/amoeba_kspace.cpp @@ -193,8 +193,7 @@ void PairAmoeba::dftmod(double *bsmod, double *bsarray, int nfft, int order) void PairAmoeba::bspline_fill() { - int i,ifr; - double xi,yi,zi; + int ifr; double w,fr,eps; double lamda[3]; @@ -525,7 +524,6 @@ void PairAmoeba::grid_mpole(double **fmp, double ***grid) double term0,term1,term2; int nlpts = (bsorder-1) / 2; - int nrpts = bsorder - nlpts - 1; // spread the permanent multipole moments onto the grid @@ -605,7 +603,6 @@ void PairAmoeba::fphi_mpole(double ***grid, double **fphi) double tuv021,tuv102,tuv012,tuv111; int nlpts = (bsorder-1) / 2; - int nrpts = bsorder - nlpts - 1; // extract the permanent multipole field at each site @@ -744,7 +741,6 @@ void PairAmoeba::grid_uind(double **fuind, double **fuinp, double ****grid) double term02,term12; int nlpts = (bsorder-1) / 2; - int nrpts = bsorder - nlpts - 1; // put the induced dipole moments onto the grid @@ -815,7 +811,6 @@ void PairAmoeba::fphi_uind(double ****grid, double **fdip_phi1, double tuv021,tuv102,tuv012,tuv111; int nlpts = (bsorder-1) / 2; - int nrpts = bsorder - nlpts - 1; // extract the permanent multipole field at each site @@ -1044,7 +1039,6 @@ void PairAmoeba::grid_disp(double ***grid) double term; int nlpts = (bsorder-1) / 2; - int nrpts = bsorder - nlpts - 1; // put the dispersion sites onto the grid @@ -1083,10 +1077,8 @@ void PairAmoeba::grid_disp(double ***grid) void PairAmoeba::kewald() { - int i,k,next; - int nbig,minfft; int nfft1,nfft2,nfft3; - double delta,rmax; + double delta; double edens,ddens; double size,slope; diff --git a/src/AMOEBA/amoeba_multipole.cpp b/src/AMOEBA/amoeba_multipole.cpp index 3e19f89233..4a43ea68f9 100644 --- a/src/AMOEBA/amoeba_multipole.cpp +++ b/src/AMOEBA/amoeba_multipole.cpp @@ -12,8 +12,7 @@ ------------------------------------------------------------------------- */ #include "pair_amoeba.h" -#include -#include + #include "amoeba_convolution.h" #include "atom.h" #include "domain.h" @@ -23,6 +22,9 @@ #include "math_const.h" #include "memory.h" +#include +#include + using namespace LAMMPS_NS; using namespace MathConst; @@ -44,20 +46,13 @@ enum{VDWL,REPULSE,QFER,DISP,MPOLE,POLAR,USOLV,DISP_LONG,MPOLE_LONG,POLAR_LONG}; void PairAmoeba::multipole() { - int i,j,ii,itype; - double e,em; + double e; double felec; - double term,fterm,vterm; + double term,fterm; double ci; double dix,diy,diz; double qixx,qixy,qixz,qiyy,qiyz,qizz; - double xq,yq,zq; - double xv,yv,zv; - double xd,yd,zd; double cii,dii,qii; - double xdfield,ydfield,zdfield; - double tem[3]; - double frcx[3],frcy[3],frcz[3]; // set cutoffs, taper coeffs, and PME params @@ -66,7 +61,6 @@ void PairAmoeba::multipole() // owned atoms - double **x = atom->x; int nlocal = atom->nlocal; // zero repulsion torque on owned + ghost atoms From ef84e0823311e0bdebf9cce3c8a97349c133d542 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 28 Apr 2022 20:08:59 -0400 Subject: [PATCH 156/585] remove error docs --- src/AMOEBA/angle_amoeba.h | 8 ------- src/AMOEBA/atom_vec_amoeba.h | 4 ---- src/AMOEBA/fix_amoeba_bitorsion.h | 36 ------------------------------- src/AMOEBA/fix_amoeba_pitorsion.h | 36 ------------------------------- src/AMOEBA/improper_amoeba.h | 13 ----------- src/AMOEBA/pair_amoeba.h | 10 --------- src/AMOEBA/pair_hippo.h | 4 ---- 7 files changed, 111 deletions(-) diff --git a/src/AMOEBA/angle_amoeba.h b/src/AMOEBA/angle_amoeba.h index 05d8041286..635bd8735e 100644 --- a/src/AMOEBA/angle_amoeba.h +++ b/src/AMOEBA/angle_amoeba.h @@ -57,11 +57,3 @@ class AngleAmoeba : public Angle { #endif #endif - -/* ERROR/WARNING messages: - -E: Incorrect args for angle coefficients - -Self-explanatory. Check the input script or data file. - -*/ diff --git a/src/AMOEBA/atom_vec_amoeba.h b/src/AMOEBA/atom_vec_amoeba.h index f7b559c74e..46953020a8 100644 --- a/src/AMOEBA/atom_vec_amoeba.h +++ b/src/AMOEBA/atom_vec_amoeba.h @@ -50,7 +50,3 @@ class AtomVecAmoeba : public AtomVec { #endif #endif - -/* ERROR/WARNING messages: - -*/ diff --git a/src/AMOEBA/fix_amoeba_bitorsion.h b/src/AMOEBA/fix_amoeba_bitorsion.h index c27fa8e547..c46f0c45dc 100644 --- a/src/AMOEBA/fix_amoeba_bitorsion.h +++ b/src/AMOEBA/fix_amoeba_bitorsion.h @@ -126,39 +126,3 @@ class FixAmoebaBiTorsion : public Fix { #endif #endif - -/* ERROR/WARNING messages: - -E: Illegal ... command - -UNDOCUMENTED - -E: CMAP atoms %d %d %d %d %d missing on proc %d at step %ld - -UNDOCUMENTED - -E: Invalid CMAP crossterm_type - -UNDOCUMENTED - -E: Cannot open fix cmap file %s - -UNDOCUMENTED - -E: CMAP: atan2 function cannot take 2 zero arguments - -UNDOCUMENTED - -E: Invalid read data header line for fix cmap - -UNDOCUMENTED - -E: Incorrect %s format in data file - -UNDOCUMENTED - -E: Too many CMAP crossterms for one atom - -UNDOCUMENTED - -*/ diff --git a/src/AMOEBA/fix_amoeba_pitorsion.h b/src/AMOEBA/fix_amoeba_pitorsion.h index d1404c2580..9c1f46a201 100644 --- a/src/AMOEBA/fix_amoeba_pitorsion.h +++ b/src/AMOEBA/fix_amoeba_pitorsion.h @@ -97,39 +97,3 @@ class FixAmoebaPiTorsion : public Fix { #endif #endif - -/* ERROR/WARNING messages: - -E: Illegal ... command - -UNDOCUMENTED - -E: CMAP atoms %d %d %d %d %d missing on proc %d at step %ld - -UNDOCUMENTED - -E: Invalid CMAP crossterm_type - -UNDOCUMENTED - -E: Cannot open fix cmap file %s - -UNDOCUMENTED - -E: CMAP: atan2 function cannot take 2 zero arguments - -UNDOCUMENTED - -E: Invalid read data header line for fix cmap - -UNDOCUMENTED - -E: Incorrect %s format in data file - -UNDOCUMENTED - -E: Too many CMAP crossterms for one atom - -UNDOCUMENTED - -*/ diff --git a/src/AMOEBA/improper_amoeba.h b/src/AMOEBA/improper_amoeba.h index 2c0cbaab6d..74423ac6c9 100644 --- a/src/AMOEBA/improper_amoeba.h +++ b/src/AMOEBA/improper_amoeba.h @@ -47,16 +47,3 @@ class ImproperAmoeba : public Improper { #endif #endif - -/* ERROR/WARNING messages: - -W: Improper problem: %d %ld %d %d %d %d - -Conformation of the 4 listed improper atoms is extreme; you may want -to check your simulation geometry. - -E: Incorrect args for improper coefficients - -Self-explanatory. Check the input script or data file. - -*/ diff --git a/src/AMOEBA/pair_amoeba.h b/src/AMOEBA/pair_amoeba.h index cd908ce534..744364df8e 100644 --- a/src/AMOEBA/pair_amoeba.h +++ b/src/AMOEBA/pair_amoeba.h @@ -482,13 +482,3 @@ class PairAmoeba : public Pair { #endif #endif - -/* ERROR/WARNING messages: - -E: Illegal ... command - -Self-explanatory. Check the input script syntax and compare to the -documentation for the command. You can use -echo screen as a -command-line option when running LAMMPS to see the offending line. - -*/ diff --git a/src/AMOEBA/pair_hippo.h b/src/AMOEBA/pair_hippo.h index f54c2516e5..ac1b65a23a 100644 --- a/src/AMOEBA/pair_hippo.h +++ b/src/AMOEBA/pair_hippo.h @@ -33,7 +33,3 @@ class PairHippo : public PairAmoeba { #endif #endif - -/* ERROR/WARNING messages: - -*/ From 31281d466d5e20d98d1568c57e0a431e18bf5a62 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Thu, 5 May 2022 13:30:55 -0600 Subject: [PATCH 157/585] fix typo in angle_amoeba virial --- src/AMOEBA/angle_amoeba.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/AMOEBA/angle_amoeba.cpp b/src/AMOEBA/angle_amoeba.cpp index bb85783b6e..e6f866f63b 100644 --- a/src/AMOEBA/angle_amoeba.cpp +++ b/src/AMOEBA/angle_amoeba.cpp @@ -421,7 +421,7 @@ void AngleAmoeba::tinker_anglep(int i1, int i2, int i3, int type, int eflag) f2[0] = -f2[0]; f2[1] = -f2[1]; f2[2] = -f2[2]; f3[0] = -f3[0]; f3[1] = -f3[1]; f3[2] = -f3[2]; f4[0] = -f4[0]; f4[1] = -f4[1]; f4[2] = -f4[2]; - ev_tally4(i1,i2,i3,14,nlocal,newton_bond,eangle,f1,f2,f3,f4); + ev_tally4(i1,i2,i3,i4,nlocal,newton_bond,eangle,f1,f2,f3,f4); } } From 329a29995275449d94edd6e2b29a1a5cc8aacf99 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Thu, 5 May 2022 13:34:32 -0600 Subject: [PATCH 158/585] virial change for bitorsions --- src/AMOEBA/fix_amoeba_bitorsion.cpp | 12 ++++++------ 1 file changed, 6 insertions(+), 6 deletions(-) diff --git a/src/AMOEBA/fix_amoeba_bitorsion.cpp b/src/AMOEBA/fix_amoeba_bitorsion.cpp index 762a84ae2e..2a028c7c96 100644 --- a/src/AMOEBA/fix_amoeba_bitorsion.cpp +++ b/src/AMOEBA/fix_amoeba_bitorsion.cpp @@ -659,12 +659,12 @@ void FixAmoebaBiTorsion::post_force(int vflag) vzy2 = zdc*(dedyid2+dedyie2) - zcb*dedyib2 + zed*dedyie2; vzz2 = zdc*(dedzid2+dedzie2) - zcb*dedzib2 + zed*dedzie2; - v[0] += vxx + vxx2; - v[1] += vyy + vyy2; - v[2] += vzz + vzz2; - v[3] += vyx + vyx2; - v[4] += vzx + vzx2; - v[5] += vzy + vzy2; + v[0] = vxx + vxx2; + v[1] = vyy + vyy2; + v[2] = vzz + vzz2; + v[3] = vyx + vyx2; + v[4] = vzx + vzx2; + v[5] = vzy + vzy2; ev_tally(nlist,list,5.0,e,v); } From 4e61530593d6c5a97af577c10c20072e0ca0daf8 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Thu, 5 May 2022 15:07:26 -0600 Subject: [PATCH 159/585] sign flip on bitorsion virial --- src/AMOEBA/fix_amoeba_bitorsion.cpp | 12 ++++++------ 1 file changed, 6 insertions(+), 6 deletions(-) diff --git a/src/AMOEBA/fix_amoeba_bitorsion.cpp b/src/AMOEBA/fix_amoeba_bitorsion.cpp index 2a028c7c96..a4db66f317 100644 --- a/src/AMOEBA/fix_amoeba_bitorsion.cpp +++ b/src/AMOEBA/fix_amoeba_bitorsion.cpp @@ -659,12 +659,12 @@ void FixAmoebaBiTorsion::post_force(int vflag) vzy2 = zdc*(dedyid2+dedyie2) - zcb*dedyib2 + zed*dedyie2; vzz2 = zdc*(dedzid2+dedzie2) - zcb*dedzib2 + zed*dedzie2; - v[0] = vxx + vxx2; - v[1] = vyy + vyy2; - v[2] = vzz + vzz2; - v[3] = vyx + vyx2; - v[4] = vzx + vzx2; - v[5] = vzy + vzy2; + v[0] = -vxx - vxx2; + v[1] = -vyy - vyy2; + v[2] = -vzz - vzz2; + v[3] = -vyx - vyx2; + v[4] = -vzx - vzx2; + v[5] = -vzy - vzy2; ev_tally(nlist,list,5.0,e,v); } From 1f4ad991779a2326aa7bdcec0fa916d76bd1f3eb Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Fri, 6 May 2022 09:33:55 -0600 Subject: [PATCH 160/585] one more virial sign flip in dispersion --- src/AMOEBA/amoeba_dispersion.cpp | 12 ++++++------ 1 file changed, 6 insertions(+), 6 deletions(-) diff --git a/src/AMOEBA/amoeba_dispersion.cpp b/src/AMOEBA/amoeba_dispersion.cpp index 1969a3bf33..5dd7aacc88 100644 --- a/src/AMOEBA/amoeba_dispersion.cpp +++ b/src/AMOEBA/amoeba_dispersion.cpp @@ -351,12 +351,12 @@ void PairAmoeba::dispersion_kspace() e = -(term1 / denom) * struc2; edisp += e; vterm = 3.0 * (fac1*erfcterm*h + fac3*expterm) * struc2/denom; - virdisp[0] += h1*h1*vterm - e; - virdisp[1] += h2*h2*vterm - e; - virdisp[2] += h3*h3*vterm - e; - virdisp[3] += h1*h2*vterm; - virdisp[4] += h1*h3*vterm; - virdisp[5] += h2*h3*vterm; + virdisp[0] -= h1*h1*vterm - e; + virdisp[1] -= h2*h2*vterm - e; + virdisp[2] -= h3*h3*vterm - e; + virdisp[3] -= h1*h2*vterm; + virdisp[4] -= h1*h3*vterm; + virdisp[5] -= h2*h3*vterm; } else term1 = 0.0; // NOTE: pre-calc this division only once gridfft[n] *= -(term1/denom); From 510e78d4d31a1ee88a3013e4830a44c20754c5ae Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Tue, 17 May 2022 12:44:11 -0600 Subject: [PATCH 161/585] test scripts --- examples/amoeba/Compare.sh | 52 + examples/amoeba/Test.sh | 66 + examples/amoeba/dump.ubi.1 | 19492 ++++++++++++++++++ examples/amoeba/dump.ubi.32 | 19492 ++++++++++++++++++ examples/amoeba/dump.water_box.amoeba.1 | 7227 +++++++ examples/amoeba/dump.water_box.amoeba.32 | 7227 +++++++ examples/amoeba/dump.water_box.hippo.1 | 7227 +++++++ examples/amoeba/dump.water_box.hippo.32 | 7227 +++++++ examples/amoeba/dump.water_dimer.amoeba.1 | 165 + examples/amoeba/dump.water_dimer.amoeba.4 | 165 + examples/amoeba/dump.water_dimer.hippo.1 | 165 + examples/amoeba/dump.water_dimer.hippo.4 | 165 + examples/amoeba/dump.water_hexamer.amoeba.1 | 297 + examples/amoeba/dump.water_hexamer.amoeba.4 | 297 + examples/amoeba/dump.water_hexamer.hippo.1 | 297 + examples/amoeba/dump.water_hexamer.hippo.4 | 297 + examples/amoeba/in.ubiquitin | 14 +- examples/amoeba/in.water_box.amoeba | 6 +- examples/amoeba/in.water_box.hippo | 6 +- examples/amoeba/in.water_dimer.amoeba | 6 +- examples/amoeba/in.water_dimer.hippo | 6 +- examples/amoeba/in.water_hexamer.amoeba | 12 +- examples/amoeba/in.water_hexamer.hippo | 12 +- examples/amoeba/log.ubi.1 | 162 + examples/amoeba/log.ubi.32 | 162 + examples/amoeba/log.water_box.amoeba.1 | 149 + examples/amoeba/log.water_box.amoeba.32 | 149 + examples/amoeba/log.water_box.hippo.1 | 153 + examples/amoeba/log.water_box.hippo.32 | 153 + examples/amoeba/log.water_dimer.amoeba.1 | 150 + examples/amoeba/log.water_dimer.amoeba.4 | 150 + examples/amoeba/log.water_dimer.hippo.1 | 154 + examples/amoeba/log.water_dimer.hippo.4 | 154 + examples/amoeba/log.water_hexamer.amoeba.1 | 149 + examples/amoeba/log.water_hexamer.amoeba.4 | 150 + examples/amoeba/log.water_hexamer.hippo.1 | 153 + examples/amoeba/log.water_hexamer.hippo.4 | 154 + 37 files changed, 72044 insertions(+), 18 deletions(-) create mode 100644 examples/amoeba/Compare.sh create mode 100644 examples/amoeba/Test.sh create mode 100644 examples/amoeba/dump.ubi.1 create mode 100644 examples/amoeba/dump.ubi.32 create mode 100644 examples/amoeba/dump.water_box.amoeba.1 create mode 100644 examples/amoeba/dump.water_box.amoeba.32 create mode 100644 examples/amoeba/dump.water_box.hippo.1 create mode 100644 examples/amoeba/dump.water_box.hippo.32 create mode 100644 examples/amoeba/dump.water_dimer.amoeba.1 create mode 100644 examples/amoeba/dump.water_dimer.amoeba.4 create mode 100644 examples/amoeba/dump.water_dimer.hippo.1 create mode 100644 examples/amoeba/dump.water_dimer.hippo.4 create mode 100644 examples/amoeba/dump.water_hexamer.amoeba.1 create mode 100644 examples/amoeba/dump.water_hexamer.amoeba.4 create mode 100644 examples/amoeba/dump.water_hexamer.hippo.1 create mode 100644 examples/amoeba/dump.water_hexamer.hippo.4 create mode 100644 examples/amoeba/log.ubi.1 create mode 100644 examples/amoeba/log.ubi.32 create mode 100644 examples/amoeba/log.water_box.amoeba.1 create mode 100644 examples/amoeba/log.water_box.amoeba.32 create mode 100644 examples/amoeba/log.water_box.hippo.1 create mode 100644 examples/amoeba/log.water_box.hippo.32 create mode 100644 examples/amoeba/log.water_dimer.amoeba.1 create mode 100644 examples/amoeba/log.water_dimer.amoeba.4 create mode 100644 examples/amoeba/log.water_dimer.hippo.1 create mode 100644 examples/amoeba/log.water_dimer.hippo.4 create mode 100644 examples/amoeba/log.water_hexamer.amoeba.1 create mode 100644 examples/amoeba/log.water_hexamer.amoeba.4 create mode 100644 examples/amoeba/log.water_hexamer.hippo.1 create mode 100644 examples/amoeba/log.water_hexamer.hippo.4 diff --git a/examples/amoeba/Compare.sh b/examples/amoeba/Compare.sh new file mode 100644 index 0000000000..9c57bb8d92 --- /dev/null +++ b/examples/amoeba/Compare.sh @@ -0,0 +1,52 @@ +# compare test runs to original runs + +# dimer + +kdiff log.water_dimer.amoeba.1 log.water_dimer.amoeba.1.test +kdiff dump.water_dimer.amoeba.1 dump.water_dimer.amoeba.1.test + +kdiff log.water_dimer.amoeba.4 log.water_dimer.amoeba.4.test +kdiff dump.water_dimer.amoeba.4 dump.water_dimer.amoeba.4.test + +kdiff log.water_dimer.hippo.1 log.water_dimer.hippo.1.test +kdiff dump.water_dimer.hippo.1 dump.water_dimer.hippo.1.test + +kdiff log.water_dimer.hippo.4 log.water_dimer.hippo.4.test +kdiff dump.water_dimer.hippo.4 dump.water_dimer.hippo.4.test + +# hexamer + +kdiff log.water_hexamer.amoeba.1 log.water_hexamer.amoeba.1.test +kdiff dump.water_hexamer.amoeba.1 dump.water_hexamer.amoeba.1.test + +kdiff log.water_hexamer.amoeba.4 log.water_hexamer.amoeba.4.test +kdiff dump.water_hexamer.amoeba.4 dump.water_hexamer.amoeba.4.test + +kdiff log.water_hexamer.hippo.1 log.water_hexamer.hippo.1.test +kdiff dump.water_hexamer.hippo.1 dump.water_hexamer.hippo.1.test + +kdiff log.water_hexamer.hippo.4 log.water_hexamer.hippo.4.test +kdiff dump.water_hexamer.hippo.4 dump.water_dimer.hippo.4.test + +# water box + +kdiff log.water_box.amoeba.1 log.water_box.amoeba.1.test +kdiff dump.water_box.amoeba.1 dump.water_box.amoeba.1.test + +kdiff log.water_box.amoeba.32 log.water_box.amoeba.32.test +kdiff dump.water_box.amoeba.32 dump.water_box.amoeba.32.test + +kdiff log.water_box.hippo.1 log.water_box.hippo.1.test +kdiff dump.water_box.hippo.1 dump.water_box.hippo.1.test + +kdiff log.water_box.hippo.32 log.water_box.hippo.32.test +kdiff dump.water_box.hippo.32 dump.water_box.hippo.32.test + +# ubiquitin + +kdiff log.ubi.1 log.ubi.1.test +kdiff dump.ubi.1 dump.ubi.1.test + +kdiff log.ubi.32 log.ubi.32.test +kdiff dump.ubi.32 dump.ubi.32.test + diff --git a/examples/amoeba/Test.sh b/examples/amoeba/Test.sh new file mode 100644 index 0000000000..54963918c6 --- /dev/null +++ b/examples/amoeba/Test.sh @@ -0,0 +1,66 @@ +# run test problems + +# dimer + +../../src/lmp_mpi < in.water_dimer.amoeba +mv log.lammps log.water_dimer.amoeba.1.test +mv dump.water_dimer dump.water_dimer.amoeba.1.test + +mpirun -np 4 ../../src/lmp_mpi < in.water_dimer.amoeba +mv log.lammps log.water_dimer.amoeba.4.test +mv dump.water_dimer dump.water_dimer.amoeba.4.test + +../../src/lmp_mpi < in.water_dimer.hippo +mv log.lammps log.water_dimer.hippo.1.test +mv dump.water_dimer dump.water_dimer.hippo.1.test + +mpirun -np 4 ../../src/lmp_mpi < in.water_dimer.hippo +mv log.lammps log.water_dimer.hippo.4.test +mv dump.water_dimer dump.water_dimer.hippo.4.test + +# hexamer + +../../src/lmp_mpi < in.water_hexamer.amoeba +mv log.lammps log.water_hexamer.amoeba.1.test +mv dump.water_hexamer dump.water_hexamer.amoeba.1.test + +mpirun -np 4 ../../src/lmp_mpi < in.water_hexamer.amoeba +mv log.lammps log.water_hexamer.amoeba.4.test +mv dump.water_hexamer dump.water_hexamer.amoeba.4.test + +../../src/lmp_mpi < in.water_hexamer.hippo +mv log.lammps log.water_hexamer.hippo.1.test +mv dump.water_hexamer dump.water_hexamer.hippo.1.test + +mpirun -np 4 ../../src/lmp_mpi < in.water_hexamer.hippo +mv log.lammps log.water_hexamer.hippo.4.test +mv dump.water_hexamer dump.water_hexamer.hippo.4.test + +# water box + +../../src/lmp_mpi < in.water_box.amoeba +mv log.lammps log.water_box.amoeba.1.test +mv dump.water_box dump.water_box.amoeba.1.test + +mpirun -np 32 ../../src/lmp_mpi < in.water_box.amoeba +mv log.lammps log.water_box.amoeba.32.test +mv dump.water_box dump.water_box.amoeba.32.test + +../../src/lmp_mpi < in.water_box.hippo +mv log.lammps log.water_box.hippo.1.test +mv dump.water_box dump.water_box.hippo.1.test + +mpirun -np 32 ../../src/lmp_mpi < in.water_box.hippo +mv log.lammps log.water_box.hippo.32.test +mv dump.water_box dump.water_box.hippo.32.test + +# ubiquitin + +../../src/lmp_mpi < in.ubiquitin +mv log.lammps log.ubi.1.test +mv dump.ubi dump.ubi.1.test + +mpirun -np 32 ../../src/lmp_mpi < in.ubiquitin +mv log.lammps log.ubi.32.test +mv dump.ubi dump.ubi.32.test + diff --git a/examples/amoeba/dump.ubi.1 b/examples/amoeba/dump.ubi.1 new file mode 100644 index 0000000000..743c5e68dc --- /dev/null +++ b/examples/amoeba/dump.ubi.1 @@ -0,0 +1,19492 @@ +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +9737 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 5.4990000000000002e+01 +0.0000000000000000e+00 4.1909999999999997e+01 +0.0000000000000000e+00 4.1909999999999997e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 9.9631 5.60476 0.008413 6.29384 29.5246 19.0744 +2 2 9.59585 5.61686 40.5223 49.6095 -15.082 -19.7261 +3 2 8.19009 6.07902 40.3725 -38.3002 -36.0401 31.6494 +4 3 7.228 5.27674 40.5663 25.6537 34.3003 -15.2325 +5 4 9.24854 5.32486 0.671238 -4.4712 -3.37565 -7.28982 +6 4 10.3108 6.54317 0.309331 -11.8382 -28.5043 -8.77497 +7 4 10.7093 4.95217 0.170763 9.79439 -2.80927 4.02983 +8 4 10.3426 6.38567 40.0332 -19.5644 -29.2331 3.89265 +9 2 9.77742 4.13431 39.9813 -28.2245 -12.7597 2.79543 +10 2 9.48564 3.81758 38.4974 43.5672 -24.1926 -8.96475 +11 5 10.1176 2.11667 38.0047 -9.19737 11.9016 12.5734 +12 2 9.21456 1.10205 39.2112 31.2522 23.9396 11.6177 +13 4 8.99594 3.48122 40.5964 28.5446 19.8656 -13.413 +14 4 10.8136 3.75653 40.1807 -3.6049 4.77507 7.99264 +15 4 10.0744 4.47991 37.8007 -16.03 7.55553 14.4224 +16 4 8.42529 3.84402 38.2863 -20.8998 9.83371 -6.83213 +17 4 9.47601 1.46641 40.2263 -2.07893 -1.87234 0.341628 +18 4 9.53146 0.065851 39.1813 1.34892 -20.4385 -9.90461 +19 4 8.1577 1.22135 39.0727 -30.8502 -1.48556 -5.54631 +20 1 8.07565 7.408 40.3203 38.3461 4.68909 -14.5778 +21 2 6.84679 8.08521 40.1985 -59.0929 12.5985 8.76694 +22 2 6.18936 7.48414 38.9048 -11.7821 0.575019 41.3478 +23 3 6.7346 7.67531 37.8418 13.9355 0.826162 -41.115 +24 4 8.95137 7.92937 40.1018 -13.7432 5.12585 4.7357 +25 4 6.17099 7.78674 41.0889 17.7478 9.29385 -16.8634 +26 2 7.04543 9.68435 40.1788 6.06779 -36.4281 36.3417 +27 2 5.78315 10.5437 40.1541 10.0153 13.6856 -31.2349 +28 2 4.87823 10.4891 38.8981 8.0898 32.2503 -21.0798 +29 3 5.10035 11.2936 37.9551 -6.38068 -25.249 23.2549 +30 1 3.78765 9.69754 38.9447 7.74282 -10.5609 -2.0448 +31 4 7.77413 9.91905 39.4336 6.93206 10.4159 -38.5359 +32 4 7.65159 10.0279 41.0787 -15.5363 -12.6708 -2.68622 +33 4 6.21166 11.5927 40.0353 -14.0103 -9.11046 14.0038 +34 4 5.24199 10.4471 41.1154 -6.90019 6.03163 0.39253 +35 4 3.64982 9.13451 39.798 -8.63839 -3.4701 -4.98201 +36 4 3.18526 9.53497 38.0983 12.4509 11.2825 18.2671 +37 1 5.03649 6.76821 39.0271 29.2025 12.626 -49.9624 +38 2 4.1742 6.30537 37.9199 2.45922 -5.77224 11.4432 +39 2 2.7281 6.64357 38.2301 -33.27 13.9739 -28.2234 +40 3 2.48558 7.27851 39.247 -7.20167 1.94081 18.2399 +41 4 4.56901 6.92293 39.8729 -36.0812 -3.10094 47.9009 +42 4 4.41115 6.93099 37.0362 4.08063 -6.87028 -11.6053 +43 2 4.30896 4.77224 37.6863 5.60806 -34.2262 -10.7438 +44 2 3.61194 3.83713 38.7945 21.7291 41.8848 -7.6362 +45 2 5.81981 4.32753 37.5156 -0.302636 -10.5955 -12.2236 +46 2 3.74184 2.37563 38.4472 -21.3499 -20.7746 -35.862 +47 4 3.79188 4.51145 36.7016 6.3754 10.432 9.00978 +48 4 2.54774 4.08441 38.8361 -15.7139 1.18722 1.17999 +49 4 4.01487 4.13828 39.7949 0.987415 -11.5324 -1.87366 +50 4 6.38959 4.49596 38.46 -5.87199 -9.93517 1.91854 +51 4 6.36771 4.97617 36.7815 -14.8228 -10.6264 -0.132465 +52 4 5.90888 3.19548 37.1534 1.72477 39.701 11.5881 +53 4 3.39383 2.18531 37.3739 6.37275 7.50384 16.1992 +54 4 3.10231 1.69487 39.022 -2.76045 -1.11045 15.6564 +55 4 4.76015 2.00007 38.4839 16.883 -5.45935 8.37891 +56 1 1.68415 6.36719 37.3348 37.2769 -12.9922 15.6035 +57 2 0.304736 6.65563 37.6783 -19.186 -35.7743 -0.468083 +58 2 54.3638 5.41499 37.39 23.5408 9.01503 -19.9847 +59 3 54.8016 4.481 36.67 -18.0502 12.9096 17.6943 +60 4 1.81134 5.6821 36.5646 -2.38907 6.77101 2.69516 +61 4 0.26398 6.68603 38.7911 -5.02605 17.0245 3.77253 +62 2 54.6928 7.87629 36.9427 9.14228 37.5998 28.2049 +63 2 0.656467 9.08157 36.7109 -0.0956801 -8.96924 -14.639 +64 2 1.56488 9.23116 35.5658 -28.7887 -16.4207 21.28 +65 2 0.518242 10.1807 37.599 12.0453 -33.0617 -42.3022 +66 2 2.2549 10.4284 35.3456 -0.685553 9.51875 21.9154 +67 2 1.26608 11.2953 37.3573 -6.55985 56.8791 72.0683 +68 2 2.14201 11.4551 36.3269 43.9558 24.4422 -61.5967 +69 4 53.8494 8.28091 37.614 11.6877 -9.2043 -14.6276 +70 4 54.1796 7.56606 36.0251 1.84695 0.514683 -15.8045 +71 4 1.67027 8.40603 34.832 -2.56062 3.42592 3.08894 +72 4 54.8243 10.1788 38.4192 -16.1978 -2.83683 23.7337 +73 4 2.90465 10.5398 34.4584 1.04403 1.06161 3.93542 +74 4 1.2044 12.0958 38.199 3.2453 -15.1518 -32.2206 +75 4 2.76002 12.4636 36.1598 -24.4207 -43.5556 11.8549 +76 1 53.0705 5.5478 37.8043 -13.4682 25.7632 10.8407 +77 2 51.945 4.63101 37.5291 33.8243 -29.5042 -37.7332 +78 2 50.7838 5.44293 36.986 4.21111 -0.422475 -19.7833 +79 3 50.2621 6.29965 37.7355 -1.55474 -12.1519 -25.7528 +80 4 52.801 6.45436 38.3333 3.61532 -42.2821 -15.9338 +81 4 52.3053 3.83112 36.7028 -14.0928 30.7972 24.0178 +82 2 51.5456 3.79903 38.7793 9.75018 1.06621 4.26496 +83 2 50.3519 2.79661 38.4832 35.7171 10.1602 1.47909 +84 2 52.8174 3.02556 39.2171 -10.4567 -30.55 12.3487 +85 4 51.3202 4.51835 39.6193 -10.3559 -7.38818 -7.14654 +86 4 50.5612 2.13754 37.5331 -9.75373 16.6535 26.894 +87 4 49.4557 3.43665 38.3668 -10.8276 -7.01925 -6.76558 +88 4 50.2008 2.17632 39.4156 -2.83245 -1.1989 -13.0752 +89 4 53.3224 3.52205 40.064 3.32837 5.49303 2.41605 +90 4 53.5736 2.86114 38.4382 5.5955 2.25759 -8.48168 +91 4 52.5769 1.98664 39.5815 -0.855844 10.0945 -0.110617 +92 1 50.4393 5.19673 35.6351 -19.7264 9.67141 42.9571 +93 2 49.1691 5.71413 35.1171 8.57247 21.8964 -7.76629 +94 2 48.0882 4.65728 35.3507 -19.9883 30.8425 14.9148 +95 3 48.2827 3.53875 34.9335 -4.48089 -38.0316 -8.70437 +96 4 50.7426 4.33028 35.1784 2.31221 -1.81777 -1.86606 +97 4 48.9711 6.6281 35.7521 -11.2206 -0.672417 -16.6265 +98 2 49.2032 6.03091 33.5236 -0.851856 65.2811 26.1578 +99 2 47.9587 6.87959 32.9935 21.6676 -24.5773 11.3759 +100 2 48.0434 7.32811 31.5002 51.7858 -12.5586 -5.19204 +101 2 48.2074 6.22405 30.3724 28.294 -23.2516 17.4346 +102 1 48.1983 6.77555 28.9911 -71.9632 -28.6889 -6.605 +103 4 49.3393 5.11986 33.0139 -2.20502 -45.3575 -27.512 +104 4 50.0955 6.63289 33.1892 -0.645528 -4.64769 17.8413 +105 4 47.8013 7.74388 33.6913 1.36166 0.224784 -7.99748 +106 4 47.0904 6.22572 33.1496 -13.2574 -0.904539 -3.87726 +107 4 49.004 7.98659 31.3992 -27.9616 -9.11626 3.58403 +108 4 47.1978 7.96127 31.27 -20.0009 14.5444 -5.73856 +109 4 47.5417 5.33248 30.4619 -18.467 18.3391 -3.45282 +110 4 49.1897 5.66674 30.5732 -8.59668 22.4275 -14.4147 +111 4 48.9982 7.27964 28.7313 27.9214 19.6218 -9.55881 +112 4 47.3685 7.40493 28.8518 27.8731 -11.8414 7.77703 +113 4 48.0065 6.08598 28.2169 17.275 11.5652 28.2934 +114 1 46.9206 5.03778 35.9702 10.3577 18.9682 5.15831 +115 2 45.6557 4.25932 36.0398 9.08885 -0.641191 -14.1305 +116 2 44.8836 4.39003 34.674 17.924 -7.95306 73.8288 +117 3 45.3111 5.13887 33.8455 4.25406 24.8458 -47.415 +118 4 46.9247 5.98842 36.4259 -8.42518 -21.6093 -9.66 +119 4 45.9322 3.16772 36.074 -4.07513 2.77881 8.35057 +120 2 44.7235 4.66099 37.2497 -7.79148 27.6424 25.8282 +121 3 44.4559 6.1146 37.2032 37.085 -18.356 15.5747 +122 2 45.2448 4.26963 38.7181 22.7861 29.0575 -8.8559 +123 4 43.727 4.13168 37.1283 17.3832 10.5512 -0.864114 +124 4 45.2761 6.59903 37.5183 -34.0557 -21.4787 -11.7364 +125 4 45.8733 4.97275 39.4014 -10.271 -7.81482 -36.7347 +126 4 45.822 3.36133 38.5799 14.1835 -15.9263 3.29814 +127 4 44.4672 3.97387 39.4102 -27.3329 -5.40347 3.37723 +128 1 43.7561 3.68722 34.6039 -10.1769 -38.5504 10.0379 +129 2 42.7898 3.65331 33.5354 16.9998 -6.12306 -24.86 +130 2 41.7694 4.78815 33.7404 2.26966 -0.410412 -51.1213 +131 3 41.2522 5.37284 32.7445 13.6537 -18.3748 18.9894 +132 4 43.5295 2.98811 35.3697 5.99608 22.1557 -16.865 +133 4 43.3523 3.94914 32.5036 -19.5402 -19.5629 37.0771 +134 2 42.0755 2.18627 33.4863 21.9074 34.2086 -29.4327 +135 2 42.9391 0.859767 33.721 -6.85443 30.257 35.6042 +136 2 42.2358 41.4668 33.4285 -9.81834 -3.65893 -31.5778 +137 2 44.2283 0.854864 32.9471 53.2312 13.9788 40.9195 +138 4 41.6117 2.20331 32.4686 -4.39523 -13.2201 2.61812 +139 4 41.2586 2.27352 34.2121 -10.6776 -10.6054 4.67488 +140 4 43.2056 0.83773 34.8124 -0.343624 1.56324 -2.51079 +141 4 42.8118 40.5237 33.3983 6.69029 -0.569008 16.3673 +142 4 41.9597 41.5484 32.3684 -17.7546 -2.75522 -9.07631 +143 4 41.3245 41.3357 34.0216 -8.62626 -3.98831 3.9624 +144 4 44.0827 0.853311 31.8896 -3.53557 -4.02089 -36.565 +145 4 44.8236 41.822 33.2847 -5.06735 25.2561 -15.1823 +146 4 44.8583 1.80877 33.1923 -14.5958 -31.7921 -4.90526 +147 1 41.5264 5.19611 34.9737 -24.8334 44.6246 6.63495 +148 2 40.6685 6.33721 35.2699 -7.96634 19.3021 -16.1623 +149 2 41.3876 7.74941 35.097 -11.5591 -21.8484 1.81155 +150 3 40.7047 8.75309 34.8417 -6.4948 4.14558 0.128999 +151 4 41.7654 4.68652 35.8013 13.1043 -20.8107 18.8359 +152 4 39.8731 6.44712 34.4383 10.8594 -11.0445 14.3032 +153 2 39.8592 6.12601 36.6093 -15.5564 -7.24317 -37.5678 +154 3 40.7443 5.88444 37.6633 23.6025 16.5055 19.3857 +155 2 38.9047 4.85477 36.5395 -12.0583 61.1722 12.675 +156 4 39.322 7.07341 36.7706 -11.99 4.52079 9.89046 +157 4 41.1265 6.74598 37.8781 -3.93551 -10.4676 -4.79928 +158 4 38.0585 4.98564 35.7954 18.0693 -6.53498 -0.435941 +159 4 38.3566 4.77654 37.5171 8.14363 -6.92414 -3.72239 +160 4 39.543 3.99696 36.3828 0.165947 -30.6128 -6.86199 +161 1 42.7342 7.80416 35.136 -13.9315 11.8694 11.7976 +162 2 43.5142 9.02936 34.9481 17.7181 -46.9691 35.2138 +163 2 44.5073 9.42999 36.0349 -55.8537 -50.7646 50.0035 +164 3 45.375 10.2125 35.7599 43.422 25.9365 -4.74067 +165 4 43.1984 6.94617 35.4338 19.599 0.647333 4.29925 +166 4 44.1406 8.86955 34.0842 9.16679 3.97336 -28.1373 +167 4 42.9197 9.91228 34.8204 -18.5221 19.1219 -12.9063 +168 1 44.2798 8.93745 37.3587 -4.0043 10.1489 -58.0949 +169 2 45.1948 9.27519 38.4238 -4.17993 36.3676 -26.0855 +170 2 46.5575 8.73344 38.0061 12.5522 -20.4469 18.6928 +171 3 46.7331 7.49794 37.7681 -6.88831 31.8582 -6.20611 +172 4 43.377 8.45873 37.5311 9.37776 2.67644 11.4724 +173 4 45.2318 10.4158 38.3238 5.33405 -13.6354 14.6161 +174 2 44.7823 8.84756 39.8415 35.39 -32.4267 -9.44324 +175 2 45.5211 9.64049 40.9405 -33.0234 -16.4934 27.578 +176 2 45.0293 11.1067 41.0295 26.955 13.1382 1.75579 +177 2 45.9939 11.883 0.056845 5.44769 -3.52142 -7.77113 +178 1 45.567 13.2463 0.389189 -21.8942 22.5552 58.7427 +179 4 44.9649 7.71121 39.9163 -1.68078 22.7299 4.94117 +180 4 43.7292 8.96914 40.0006 -34.3585 3.91778 0.788359 +181 4 46.6326 9.56148 40.8729 -4.12637 -0.755434 -1.7729 +182 4 45.1589 9.15652 0.052119 21.5355 9.01144 -26.2886 +183 4 44.0384 11.1525 41.4882 -17.6691 -1.8484 1.78047 +184 4 44.9645 11.6456 40.0488 1.32443 -5.52779 3.51863 +185 4 46.9936 12.0079 41.4163 -11.0521 -7.71607 17.8496 +186 4 46.0863 11.2417 1.01939 6.64185 25.7549 -16.0759 +187 4 45.6176 13.9315 41.5535 6.39074 -1.54943 -2.93714 +188 4 46.1207 13.6426 1.21669 -15.3499 -18.2055 -38.2327 +189 4 44.572 13.3465 0.725918 28.6554 -12.4083 -12.8179 +190 1 47.5723 9.62675 38.0225 1.62241 16.525 -13.2778 +191 2 48.9413 9.31976 37.6447 28.3505 6.17866 3.85392 +192 2 49.7947 9.65595 38.897 -51.2415 76.6103 -24.0977 +193 3 49.6063 10.7902 39.4401 12.9093 -42.4425 -12.577 +194 4 47.4538 10.6389 38.3066 -1.81401 -22.4625 -4.08398 +195 4 49.0905 8.23756 37.4201 -8.03606 -0.867672 -0.903629 +196 2 49.3577 10.1392 36.3514 -15.5639 -8.86216 -34.5575 +197 3 48.3381 9.84531 35.2995 20.2521 4.60838 26.9691 +198 2 50.6821 9.73379 35.6575 -13.1705 -1.52152 26.2758 +199 4 49.443 11.2403 36.5183 -14.2645 -0.263993 8.70321 +200 4 47.5106 10.2398 35.5579 0.218555 2.62212 3.26783 +201 4 50.9323 10.3465 34.7687 -2.88514 -3.55444 -7.60949 +202 4 50.7732 8.65192 35.4951 -3.14548 -9.24106 -12.1943 +203 4 51.4763 9.94768 36.3674 17.1427 5.0591 10.0517 +204 1 50.5022 8.69828 39.4305 24.0939 -43.466 77.1583 +205 2 51.0483 8.71922 40.8082 -0.802123 10.2433 -32.8315 +206 2 52.5183 8.33859 40.7231 46.1376 25.1574 58.8821 +207 3 52.8914 7.33748 40.1143 13.0446 10.4001 -14.6089 +208 4 50.6189 7.73433 39.1341 -5.48208 -8.91176 -29.3848 +209 4 51.0045 9.75097 41.1725 -0.547397 17.2241 4.09797 +210 2 50.2922 7.85282 41.8455 19.6626 -50.7873 -7.63422 +211 2 50.2811 6.29504 41.471 -17.2864 -17.6708 26.7503 +212 2 48.8668 8.31684 0.212195 -17.3783 63.506 12.4232 +213 2 49.3691 5.38294 0.512646 14.3884 65.6628 -4.02696 +214 4 50.9326 7.9114 0.860642 -12.3241 5.1929 3.57402 +215 4 51.3127 5.83882 41.5287 -4.74499 10.5855 -5.5164 +216 4 49.8921 6.13652 40.4532 1.6457 0.843055 -11.9856 +217 4 48.0317 8.06123 41.424 13.0217 -7.20036 -2.54126 +218 4 48.8693 9.49201 0.254246 -0.917701 -32.4673 -2.46528 +219 4 48.5263 8.05212 1.23597 1.41612 -6.96817 -0.649274 +220 4 48.2816 5.57755 0.309314 6.34191 -1.32326 5.14384 +221 4 49.6363 5.72968 1.56057 -11.1106 -15.1353 -5.99489 +222 4 49.54 4.32324 0.397743 7.27301 -24.1582 -2.3836 +223 1 53.3925 9.14738 41.5454 -19.7766 -15.6836 -47.6014 +224 2 54.8543 9.29866 41.641 -12.5045 -20.0873 29.727 +225 2 0.407838 8.25913 0.762984 -29.7207 32.5524 -37.8245 +226 3 54.8643 8.2564 1.86493 17.0269 -29.0845 20.332 +227 4 52.9285 9.69819 0.341812 -9.11605 14.2566 13.2302 +228 4 0.291486 9.0623 40.6877 9.99865 -5.39191 -34.8298 +229 2 0.359683 10.7121 0.203065 -6.90664 -3.88067 -14.6485 +230 3 54.4765 11.8025 41.752 -11.2022 -21.2627 -5.88002 +231 2 1.6614 11.1001 41.4135 2.5167 -27.9916 -13.3179 +232 4 0.487415 10.6137 1.28953 0.410521 18.1219 13.0764 +233 4 54.0953 12.1937 0.613553 1.59003 1.59721 11.7532 +234 4 1.92456 12.0955 41.7398 14.8193 23.7252 4.53742 +235 4 1.52762 11.126 40.2979 3.61624 1.93597 7.36374 +236 4 2.5241 10.4069 41.6364 -8.38015 7.04993 1.52106 +237 1 1.45864 7.53391 0.367476 0.545631 9.71791 -21.8799 +238 2 2.25081 6.65311 1.15507 26.446 -0.0641839 -18.4938 +239 2 3.7671 6.96757 0.917085 -57.4365 -22.4689 85.9929 +240 3 4.15047 7.41488 41.7757 21.4144 12.1214 -29.7802 +241 4 1.8001 7.62601 41.3064 3.76941 -0.348546 3.21752 +242 4 1.98413 6.84865 2.19976 1.77378 -4.57114 13.3572 +243 2 1.98593 5.20856 0.673411 -39.0557 8.05152 -2.47083 +244 2 0.499001 4.77546 0.950638 51.92 -35.3278 3.54994 +245 2 0.302449 3.38226 0.307039 12.2804 5.92691 27.6936 +246 2 0.318833 4.59091 2.46762 -57.1886 17.9845 23.4913 +247 4 2.62035 4.47984 1.15306 24.0478 -12.5257 10.4353 +248 4 2.17019 5.14075 41.4887 6.74012 -0.473312 -2.7006 +249 4 54.8482 5.46061 0.448133 -33.0903 28.7369 -7.07308 +250 4 54.2241 3.15851 0.337643 -14.6094 -12.7265 -2.24176 +251 4 0.881511 2.58656 0.876485 -8.96903 11.0382 -11.5819 +252 4 0.635114 3.38296 41.1822 2.70741 -4.49002 -20.1461 +253 4 0.991181 3.80938 2.86091 2.53728 -4.51346 7.06316 +254 4 54.1796 4.30541 2.72425 38.6722 3.44969 -10.622 +255 4 0.495432 5.52724 3.08531 2.73328 -11.7655 -13.2166 +256 1 4.49387 6.66874 2.05101 59.25 35.5651 -63.8633 +257 2 5.97745 6.82619 2.08157 -13.5783 -40.6566 -15.6714 +258 2 6.57448 5.47381 2.54294 67.6927 12.9151 50.3283 +259 3 7.53922 5.43765 3.33186 -5.78511 6.85237 -12.8739 +260 4 4.10191 6.33546 2.9164 -11.2688 -10.0369 11.6191 +261 4 6.35409 6.85375 1.02753 1.73229 12.3732 3.55997 +262 2 6.47001 8.00523 2.96248 -35.1701 -2.47648 -9.01657 +263 2 6.52316 9.38515 2.26526 -52.089 -36.3571 -52.5381 +264 2 6.66039 10.5311 3.17647 23.2175 30.5211 32.7092 +265 3 7.81872 10.9467 3.49478 5.10838 -9.19539 -6.96115 +266 3 5.64173 11.0573 3.6767 -20.5888 -1.64097 0.158765 +267 4 7.42654 7.87231 3.41702 35.4584 -16.2138 5.63399 +268 4 5.81838 7.86205 3.84167 -4.54492 27.3919 10.2645 +269 4 5.56237 9.49095 1.59664 20.5708 1.89307 25.306 +270 4 7.29681 9.38215 1.47849 13.2355 1.21078 1.19218 +271 1 6.08096 4.31767 2.17259 -39.414 -15.8224 -24.7678 +272 2 6.39518 2.91476 2.36043 4.12081 37.0723 19.1814 +273 2 7.75633 2.62628 1.79624 63.8838 -9.4865 -25.3011 +274 3 8.33634 3.36937 0.946953 -27.4154 -16.213 26.3787 +275 4 5.28658 4.43126 1.58002 -24.0887 -1.16266 -20.2566 +276 4 6.54455 2.77577 3.45017 -8.86613 -5.70482 8.60941 +277 2 5.25427 2.02933 1.82805 -30.6144 -48.6247 5.61864 +278 2 3.85552 2.1153 2.66383 78.486 27.413 32.1434 +279 2 4.87851 2.27508 0.297641 -10.4566 -15.7718 22.2154 +280 4 5.65998 0.937168 1.99721 -15.6319 23.5495 -14.0675 +281 4 3.98898 1.63213 3.72107 -1.04911 23.3354 -24.3429 +282 4 3.15409 1.48884 2.20213 -45.477 -24.0418 -26.2275 +283 4 3.51802 3.20813 2.70746 -2.40249 -20.6527 6.6832 +284 4 4.39172 3.24426 0.119355 -1.44384 9.21297 0.0772101 +285 4 4.19746 1.51559 41.6955 12.4172 8.09212 16.5491 +286 4 5.82002 2.28129 41.6778 17.5327 1.3005 -22.4945 +287 1 8.43941 1.53208 2.30673 1.7292 42.4201 -39.4356 +288 2 9.76672 1.10452 1.81012 11.995 -19.5667 23.3003 +289 2 9.60964 41.7637 0.921245 4.05677 21.7498 -11.1929 +290 3 8.59567 41.087 1.06007 7.18507 -15.5872 -8.58634 +291 4 7.90606 0.81761 2.76924 -8.42032 -19.931 16.3865 +292 4 10.4026 1.87877 1.34085 -18.5158 15.1062 -12.7744 +293 2 10.6232 0.647963 3.0246 -34.7832 -39.5023 14.4787 +294 2 11.0993 1.6812 4.04079 16.2934 16.5377 23.708 +295 2 12.4719 2.27616 3.59128 -46.8378 -2.52013 6.7155 +296 3 13.4675 1.63575 4.02276 22.0629 14.477 -13.463 +297 3 12.4471 3.24187 2.73298 15.8946 -22.2661 28.0778 +298 4 11.4641 0.045385 2.63277 10.8271 5.92943 5.75519 +299 4 10.0353 41.7446 3.607 8.35649 20.5438 -12.0897 +300 4 11.2832 1.11765 5.0427 -4.51453 13.9694 -21.6118 +301 4 10.341 2.4932 4.3105 9.65416 -13.2167 -8.7997 +302 1 10.6494 41.4676 0.039711 8.78515 0.440053 18.9323 +303 2 10.7217 40.2184 41.1909 10.2574 -28.5822 12.1248 +304 2 10.6889 38.8907 0.171469 -17.3791 70.2346 -13.2363 +305 3 10.1368 37.8928 41.652 0.864281 -20.5458 12.6113 +306 4 9.82473 40.2067 40.5786 -14.2689 -8.84554 -18.4029 +307 2 12.0478 40.1799 40.3262 -31.3786 20.6535 10.6233 +308 2 12.4388 41.6551 40.4794 16.223 20.8678 -10.392 +309 2 11.8805 0.34241 41.7792 -28.1233 -36.7072 -34.4959 +310 4 11.9102 39.8982 39.2292 -1.08614 0.893428 17.4874 +311 4 12.7409 39.4563 40.8087 9.93344 3.46544 -3.32375 +312 4 12.0845 0.391154 39.5895 8.62314 -16.2997 14.2071 +313 4 13.5502 41.7447 40.5643 -1.70925 0.910467 -12.4735 +314 4 11.7305 1.40344 41.6414 -9.5626 24.5309 -2.35213 +315 4 12.5687 0.26268 0.684216 19.8182 -9.73862 27.9097 +316 1 11.1854 39.0885 1.40191 34.1901 -11.3327 18.3686 +317 2 11.4785 38.09 2.41707 -37.5808 13.2867 4.32174 +318 2 10.2405 37.7763 3.3402 -0.155099 -13.1844 6.87934 +319 3 10.4378 36.9653 4.27207 -11.6928 9.67513 -22.7546 +320 4 11.6756 39.9703 1.62918 -8.97807 -2.58442 -2.36164 +321 4 11.7153 37.147 1.89269 -3.37493 -11.1801 -2.58831 +322 2 12.7263 38.4682 3.25859 -32.7454 -15.529 27.3397 +323 3 12.5885 39.7408 3.87129 1.54426 18.5893 -11.5354 +324 4 13.5945 38.4441 2.61946 23.9879 5.88222 -14.7576 +325 4 12.9197 37.685 4.04183 -3.566 10.9198 -2.82194 +326 4 11.9285 39.8531 4.57214 8.5625 -16.1459 -5.7164 +327 1 8.98961 38.3717 3.14779 19.3135 28.1448 -76.0315 +328 2 7.78009 38.1002 3.90315 -4.26896 22.0341 0.229441 +329 2 6.83069 37.1869 3.18241 -25.8564 -25.3069 -16.1867 +330 3 6.84398 36.9785 1.97125 20.9058 23.903 -13.4458 +331 4 8.79049 38.9506 2.20714 10.5577 -30.8167 54.9659 +332 4 8.11274 37.5073 4.75427 1.14536 -6.32615 23.8911 +333 2 7.0077 39.4163 4.32571 4.21253 -4.87986 18.678 +334 2 7.75781 40.1168 5.42156 46.58 -14.1846 12.934 +335 3 8.30143 41.2262 5.21331 -14.6188 11.6514 -5.86083 +336 3 8.10545 39.4797 6.46784 -18.045 3.20128 -4.6129 +337 4 6.01572 39.173 4.78754 -1.72287 0.045533 -10.2864 +338 4 6.87032 40.2048 3.55457 -4.98407 -10.6589 -12.5629 +339 1 5.91154 36.4899 3.88964 18.6928 -0.691686 25.3425 +340 2 4.98537 35.571 3.20749 -24.0931 31.8814 30.8723 +341 2 3.79198 36.4499 2.67545 58.5623 50.3783 54.6165 +342 3 3.60244 37.6478 3.05835 4.98938 -42.2114 -12.2812 +343 4 5.945 36.5545 4.93654 -10.5756 -4.83423 -16.3239 +344 4 5.5221 35.038 2.40161 -3.05594 2.46612 -11.4716 +345 2 4.40384 34.4728 4.15145 -1.70261 45.9252 5.92389 +346 3 3.98498 35.0725 5.41787 -8.00202 -46.5665 -16.5053 +347 2 5.48475 33.4747 4.46048 0.249803 -29.9924 71.6177 +348 4 3.54337 34.0389 3.61058 -6.82183 -12.9435 7.69028 +349 4 3.62675 34.2747 5.86698 6.39679 27.749 2.05336 +350 4 5.85279 32.9868 3.57629 11.3184 -16.9973 -22.3871 +351 4 5.09248 32.6743 5.23041 8.97186 17.4623 -32.7541 +352 4 6.34746 33.9006 5.03324 -0.476546 4.78606 -11.5797 +353 1 3.00152 35.8184 1.87366 -46.1462 -42.5584 -55.0681 +354 2 1.77021 36.3468 1.35692 -36.7765 14.163 11.1031 +355 2 0.721356 36.5788 2.57059 18.2386 -29.7925 23.2574 +356 3 54.9678 37.5551 2.63992 10.9193 3.0322 -8.68025 +357 4 3.31287 34.9586 1.40066 1.19836 -3.77239 4.28893 +358 4 2.05059 37.3327 0.922928 -11.4048 10.7741 9.22697 +359 2 1.07197 35.5705 0.158527 41.3495 -39.9506 -9.05678 +360 2 1.73776 35.9497 40.6674 -26.4234 39.8053 33.0301 +361 2 54.5322 35.7209 0.133627 -14.8072 -12.0564 -1.20894 +362 2 3.23928 35.9487 40.63 7.11928 -24.1756 -12.68 +363 4 1.32474 34.4514 0.269568 -7.211 20.0201 5.35532 +364 4 1.47926 37.0502 40.6385 -3.87579 -7.90549 -26.2729 +365 4 1.36122 35.3789 39.7771 -4.72819 3.84386 12.155 +366 4 54.087 35.0558 41.2526 3.68912 7.63158 3.17282 +367 4 54.2076 36.7772 41.8385 0.949253 -6.55132 4.09096 +368 4 54.0676 35.3362 1.10912 4.22691 12.456 -17.368 +369 4 3.57003 34.9443 40.8434 9.13412 -24.8126 8.40569 +370 4 3.78301 36.5792 41.3142 5.34684 18.5101 18.1918 +371 4 3.6567 36.127 39.6372 -0.20476 7.44967 -14.9904 +372 1 0.712989 35.6055 3.58431 38.0557 9.26554 -59.6495 +373 2 0.05279 35.6483 4.83915 -15.0961 2.42646 38.658 +374 2 0.191347 37.0144 5.48801 7.00468 33.8104 1.40802 +375 3 54.154 37.7008 5.76148 35.4113 -11.6645 -8.2681 +376 4 1.23482 34.733 3.35856 -11.2418 4.01634 10.8504 +377 4 53.9671 35.581 4.69172 -20.2496 -5.13772 -12.456 +378 2 0.463881 34.4895 5.81355 17.031 15.9659 -33.5139 +379 2 54.8083 34.3393 7.16558 -30.7527 -16.2072 -11.1445 +380 2 0.00712 35.4957 8.10271 3.59003 -8.69902 15.3198 +381 3 54.0967 36.3529 8.34542 -1.77732 -9.94333 -12.6544 +382 3 1.07192 35.4587 8.7399 35.3598 16.353 18.5034 +383 4 1.56574 34.5304 5.94519 0.590681 0.639559 4.32925 +384 4 0.280894 33.5741 5.23349 -1.52963 -16.3279 0.16603 +385 4 0.223173 33.3947 7.64873 -6.8885 8.42796 -3.46601 +386 4 53.7112 34.1554 6.97481 9.65493 -2.46487 7.60139 +387 1 1.50649 37.4152 5.65526 -22.458 -31.2308 -17.0045 +388 2 2.02438 38.6379 6.15097 -3.22056 29.1656 36.4104 +389 2 1.58588 39.8651 5.40701 -13.5031 20.9194 -76.104 +390 3 1.07209 40.8553 5.93778 8.03965 -15.1327 11.1864 +391 4 2.24702 36.741 5.38136 -6.00826 1.88497 2.51587 +392 4 1.72629 38.833 7.20228 -22.1923 -11.9073 0.0585309 +393 2 3.51949 38.6121 6.24971 43.6984 -50.5664 -0.0787057 +394 2 4.11017 39.7004 7.10642 -5.48661 12.2779 -12.8977 +395 3 4.55887 40.7033 6.57435 6.12607 11.2234 -5.55098 +396 1 3.97545 39.5562 8.42942 -13.6958 7.00999 41.6346 +397 4 3.92653 38.5973 5.19958 6.67843 9.43594 11.2804 +398 4 3.90699 37.6191 6.72902 -10.8805 23.4385 -12.7616 +399 4 3.35162 38.8096 8.83526 13.2612 9.60447 -6.60232 +400 4 4.25023 40.3377 9.09595 -2.56729 -20.1743 -21.9158 +401 1 1.64621 39.8034 3.99517 -50.1719 52.4074 67.8966 +402 2 0.960547 40.8538 3.14427 -3.37695 -31.9032 -17.009 +403 2 54.4047 41.0035 3.47138 71.1401 19.2662 2.3079 +404 3 53.9887 0.221409 3.63964 -22.8765 18.4333 9.81455 +405 4 2.07659 38.9926 3.63308 18.9969 -31.9912 -34.7926 +406 4 1.39808 41.8727 3.34889 0.835518 -9.01277 1.27119 +407 2 1.14841 40.4887 1.56595 -9.49555 20.2148 39.7014 +408 2 0.469253 41.6189 0.677094 10.8075 11.2475 47.495 +409 2 2.6528 40.4777 1.25625 -15.459 -47.3647 -39.6369 +410 4 0.776571 39.4398 1.40308 -11.1955 11.1351 -6.38222 +411 4 54.3852 41.8501 0.825468 -5.0709 -17.7069 -2.05205 +412 4 0.696071 41.5065 41.5456 0.0730393 -4.82529 -32.9133 +413 4 0.904174 0.691668 0.985463 6.30616 -9.41897 -5.2369 +414 4 2.64269 40.3122 0.13166 16.7998 18.1471 15.5753 +415 4 3.13789 39.5289 1.58622 -1.56816 4.1145 9.56394 +416 4 3.29805 41.2779 1.59825 6.1243 20.9887 1.16769 +417 1 53.684 39.9214 3.65257 -36.1976 13.6917 8.19643 +418 2 52.3006 39.9493 4.06589 -56.8626 -17.5359 -10.0305 +419 2 52.042 40.5256 5.46425 9.62461 10.2848 -5.14962 +420 3 51.0331 41.2228 5.70144 14.4944 -11.372 -4.23176 +421 4 54.0189 39.0607 3.30247 15.8062 -40.5534 -6.95561 +422 4 51.6931 40.6476 3.38276 19.0563 -8.07776 7.22418 +423 2 51.5622 38.4976 3.96193 14.5706 2.1127 21.5154 +424 2 51.4158 37.9814 2.50572 24.752 -20.928 -15.9835 +425 2 51.0077 36.4305 2.37064 11.3099 30.9145 9.08043 +426 2 50.8522 35.9939 0.907307 -46.4939 -7.09254 -49.7464 +427 1 50.1475 34.7025 0.671588 69.6077 -32.405 2.84717 +428 4 50.6006 38.4842 4.55016 3.73478 6.81079 -18.2086 +429 4 52.1831 37.7463 4.55262 -3.81101 12.3643 -13.1539 +430 4 52.4118 38.1657 2.02278 1.77015 -18.5404 7.48984 +431 4 50.8584 38.5927 1.79489 -26.3581 9.74254 8.34414 +432 4 50.0453 36.2246 2.88499 -2.56193 3.57961 3.68626 +433 4 51.7703 35.8375 2.92238 0.215708 -6.73604 -5.33103 +434 4 51.7691 36.0437 0.240386 -6.2594 -4.10885 19.6388 +435 4 50.1039 36.686 0.3716 22.9763 1.60597 16.3794 +436 4 50.5914 33.8993 1.10828 2.95648 12.8391 18.7814 +437 4 50.3001 34.3737 41.6268 -19.3387 19.3411 -4.27099 +438 4 49.2006 34.6111 0.961468 -24.084 7.88088 -0.582308 +439 1 53.0235 40.2561 6.35237 -32.3128 10.4579 -5.0201 +440 2 53.1129 40.7256 7.70074 -41.6363 -1.15369 57.3167 +441 2 53.1798 0.352689 7.77253 -34.9991 -20.8035 37.2736 +442 3 52.5119 1.01286 8.63006 21.7579 -17.6925 -30.8538 +443 4 53.6931 39.5673 6.06584 22.7894 -18.2937 1.39271 +444 4 52.0865 40.4844 8.3065 35.7608 3.68212 -29.1988 +445 2 54.2701 40.0034 8.46069 6.08948 28.5921 -6.02695 +446 4 54.5971 40.5153 9.39975 -22.234 -14.34 10.1754 +447 4 0.201561 40.2092 7.93116 13.6903 -2.08726 -21.3806 +448 4 54.1655 38.8939 8.41526 -0.559105 0.118215 15.5404 +449 1 53.9752 0.884949 6.87383 32.3465 35.364 -24.1241 +450 2 54.062 2.35993 6.75215 -1.13821 -0.709889 -34.8218 +451 2 52.7471 3.02097 6.14186 4.92946 35.4069 59.7439 +452 3 52.3227 4.16587 6.4978 18.9545 -33.4145 3.00952 +453 4 54.7345 0.266534 6.4753 -18.8262 24.4346 -1.05702 +454 4 54.2802 2.76759 7.79054 -12.1814 3.84369 -14.3249 +455 2 0.185451 2.81859 5.73187 27.2059 46.9588 30.4236 +456 2 1.71808 2.36893 6.1571 -63.9259 -20.0653 -29.4315 +457 2 1.9764 2.63004 7.63437 43.6306 13.7343 2.97159 +458 2 3.27263 1.81187 8.04275 -33.9139 -3.58936 -6.58926 +459 1 3.78328 2.11956 9.34176 26.6398 21.4152 24.507 +460 4 0.173809 4.01773 5.82442 4.54198 -39.0295 -6.50933 +461 4 54.8792 2.64498 4.65574 11.0791 -10.5686 10.592 +462 4 2.43618 2.90609 5.45978 -2.35628 -10.1976 10.4282 +463 4 1.76796 1.2289 6.01344 4.57023 21.5888 -8.89179 +464 4 1.21473 2.41369 8.37281 -19.449 -19.8593 5.28327 +465 4 2.02309 3.72579 7.75906 18.9296 5.96095 -1.30777 +466 4 4.11389 1.88412 7.33652 2.51142 0.584915 -8.00636 +467 4 2.91513 0.727469 8.06593 14.1612 11.4678 0.952909 +468 4 3.87966 1.33238 9.93849 2.65093 -23.7146 9.43734 +469 4 3.29203 2.7681 9.89323 -42.3935 13.6729 9.41431 +470 4 4.65765 2.6209 9.4154 12.4458 -11.5538 -21.8273 +471 1 52.0387 2.32512 5.28273 -51.3661 -11.8477 -11.6622 +472 2 50.6641 2.72274 4.84157 25.7857 6.93126 13.1254 +473 2 49.5414 2.57609 5.91007 27.6149 -7.37739 5.45836 +474 3 48.7805 3.52104 6.09585 -8.9672 -1.93713 4.87304 +475 4 52.4681 1.55108 4.79165 6.19099 -18.5603 -5.58783 +476 4 50.6769 3.82983 4.70864 1.41274 -1.50214 -10.3294 +477 2 50.3587 2.05695 3.49156 -22.4167 -18.5545 -8.10533 +478 2 51.392 2.35646 2.3419 -24.5199 12.8001 2.40788 +479 2 48.9327 2.41504 2.97856 -9.14079 -2.86031 26.3031 +480 2 51.1945 1.4129 1.15651 29.522 -13.6455 -15.5517 +481 4 50.3189 0.937191 3.7523 9.08136 15.4094 -11.3523 +482 4 52.3823 2.12188 2.68097 31.5971 -0.36407 15.4796 +483 4 51.4014 3.46798 2.06765 -1.078 -19.9026 -0.0406259 +484 4 48.2117 2.12758 3.78451 -1.04241 22.2186 2.00084 +485 4 48.5813 1.67256 2.28636 2.21501 -12.0529 -35.8697 +486 4 48.7327 3.44552 2.54328 5.48386 -12.5705 11.3103 +487 4 52.1623 1.3706 0.452926 -36.5132 5.61179 20.4585 +488 4 50.2881 1.70969 0.600596 -1.11419 -0.409473 -10.6314 +489 4 51.0211 0.353877 1.53511 3.53067 13.7442 -8.50616 +490 1 49.5623 1.51743 6.77214 29.0905 -0.0770965 -25.5222 +491 2 48.7084 1.41716 7.91723 -3.12505 -21.6463 4.96918 +492 2 48.8549 2.61932 8.82546 31.903 20.2748 29.0475 +493 3 47.906 3.05048 9.46897 -16.8524 2.35798 -10.3438 +494 4 50.2118 0.710522 6.59294 -12.9921 18.0739 4.61122 +495 4 47.6425 1.393 7.52359 9.91609 0.328738 10.372 +496 2 49.0787 0.089334 8.73016 -60.0302 -9.6098 -44.8862 +497 2 48.2852 41.7441 10.0242 3.18066 15.7764 -9.96769 +498 2 46.7826 0.060746 9.96682 -2.34726 -14.6607 41.7592 +499 3 46.2233 0.511631 10.9878 -5.96974 4.10403 -23.4495 +500 1 46.1388 41.3329 8.97776 32.9533 20.065 15.0282 +501 4 50.1182 0.035639 8.93296 42.8084 2.68407 12.3764 +502 4 48.8904 41.1121 8.0025 3.88899 17.9501 19.4277 +503 4 48.6104 0.602172 10.7954 4.73737 -18.8132 -0.914642 +504 4 48.4759 40.6816 10.3394 0.165969 9.19265 10.3013 +505 4 46.673 40.8953 8.25882 14.2049 -15.3063 -26.5369 +506 4 45.1569 41.364 8.91958 -49.0994 -2.53611 0.320683 +507 1 50.1114 3.13932 9.06291 -28.12 32.8195 0.337886 +508 2 50.3404 4.32895 9.98795 -1.65029 -57.226 -17.8628 +509 2 50.0322 5.66893 9.41362 -36.2334 -9.83443 -38.9072 +510 3 49.3598 6.44562 10.1062 15.3309 6.40082 -5.38514 +511 4 50.9085 2.84633 8.5071 12.3092 -10.0263 -3.45928 +512 4 49.5835 4.28149 10.7848 -3.38143 -13.253 14.1405 +513 2 51.7461 4.22789 10.5468 25.7206 14.4209 20.1557 +514 2 51.9023 5.17188 11.7283 -67.9962 -1.36338 64.1829 +515 3 50.9364 5.19004 12.6002 28.9599 1.18541 -41.9912 +516 3 52.9319 5.83594 11.9785 18.8411 2.87417 -24.5577 +517 4 52.4276 4.5214 9.72474 12.6887 -3.13287 0.413374 +518 4 52.058 3.21563 10.9647 -9.24198 7.66389 -16.6414 +519 1 50.112 5.78532 8.03139 7.52033 29.602 25.459 +520 2 49.6799 7.08933 7.40639 14.3534 -30.8181 22.5674 +521 2 48.2409 7.17209 6.9711 -2.24553 44.7474 7.57528 +522 3 47.5844 8.22961 7.08968 18.1939 -9.81929 5.41459 +523 4 50.7064 5.09112 7.53173 -12.638 14.3936 -6.22521 +524 4 49.7159 7.84119 8.19837 -7.36252 7.51614 21.2329 +525 2 50.7023 7.64954 6.44039 -16.0213 -40.4967 -48.4302 +526 2 50.7257 6.82423 5.08423 -13.7427 47.9405 2.4816 +527 2 51.6418 7.28287 3.94021 29.8472 39.248 73.299 +528 2 53.127 6.98483 4.24688 1.29977 19.7271 -18.9866 +529 1 53.757 7.95176 5.17575 -11.1866 13.844 -62.5277 +530 4 51.636 7.68275 6.97838 28.3767 1.23741 1.58475 +531 4 50.4129 8.66535 6.18803 -0.179632 23.7408 -3.11047 +532 4 49.7187 7.01043 4.64523 -5.97611 -10.1095 1.48316 +533 4 50.8061 5.7562 5.2149 3.4405 -22.8364 10.0865 +534 4 51.5118 8.41472 3.72654 -1.36136 -26.6124 -3.74792 +535 4 51.4228 6.66542 3.12568 -20.7249 -22.8033 -58.4365 +536 4 53.6095 7.03345 3.2004 3.85152 5.93338 28.8514 +537 4 53.3314 5.96083 4.57939 -0.112253 -9.13532 8.29834 +538 4 53.309 8.86524 5.1699 0.162268 -2.42959 1.84412 +539 4 54.6672 8.17057 4.81193 19.2107 -0.812718 7.6593 +540 4 53.869 7.69009 6.11536 0.991087 -15.435 33.6166 +541 1 47.7293 6.1299 6.36528 -13.6545 -50.1986 -45.913 +542 2 46.4151 6.11998 5.73127 12.5517 -4.35851 26.1033 +543 2 45.4457 5.24236 6.50095 -54.5114 -4.35957 -22.3583 +544 3 44.2134 5.34166 6.22856 33.5613 3.36987 15.344 +545 4 48.2957 5.29705 6.08439 -4.65701 16.0313 11.2062 +546 4 46.0246 7.14829 5.83676 -12.413 4.85954 -1.2939 +547 2 46.3966 5.7006 4.23247 16.9743 -35.0719 19.3242 +548 2 46.8471 6.79722 3.31369 7.95245 13.9142 -51.9109 +549 2 46.0679 8.12855 3.29075 19.7668 12.2354 20.4517 +550 3 44.9703 8.28242 2.6836 -5.20426 -7.76074 -7.99938 +551 3 46.5716 9.08042 3.9624 -5.49585 -3.27174 -8.75295 +552 4 45.3525 5.37075 3.98324 7.30106 1.55378 -6.68576 +553 4 47.1483 4.79199 4.10624 -28.8106 21.423 0.303262 +554 4 47.0017 6.41037 2.24023 -12.0684 6.13088 18.9752 +555 4 47.8815 7.05675 3.60692 6.175 4.12296 2.89493 +556 1 45.8802 4.28795 7.34048 -32.7588 9.8199 -6.22093 +557 2 44.9801 3.41661 8.05582 7.11941 -0.762777 6.83491 +558 2 44.2841 2.32798 7.24802 57.2007 25.2815 -35.4523 +559 3 43.4338 1.62321 7.71908 -38.784 -24.7635 26.1598 +560 4 46.8556 4.13399 7.46211 34.7056 -9.13536 7.69054 +561 4 45.5867 2.90913 8.82837 -2.10841 -5.06197 5.41207 +562 4 44.2233 4.00883 8.63057 1.71074 -0.990438 -6.10924 +563 1 44.7516 2.08483 5.98824 -37.8462 -38.4135 -8.16449 +564 2 44.1597 1.01431 5.13579 -9.65639 -34.378 14.28 +565 2 44.8664 41.5016 5.49089 -11.1964 37.9598 3.64882 +566 3 46.103 41.4369 5.57345 -11.1149 2.47206 2.88353 +567 4 45.5262 2.474 5.47152 21.0389 22.2918 12.8005 +568 4 43.0172 0.862184 5.40503 31.5022 14.6416 -15.142 +569 2 44.4162 1.4085 3.60515 5.8653 -21.2021 14.2009 +570 2 43.5161 2.65984 3.27425 41.0117 -18.0627 24.5931 +571 2 44.2213 0.116838 2.67583 -30.001 3.65408 12.6342 +572 2 43.604 3.10049 1.82796 -41.0466 14.5447 22.3036 +573 4 45.4923 1.71966 3.57573 -0.138156 -3.02814 -11.6903 +574 4 43.8008 3.50537 3.97163 -2.46499 -4.10631 -11.566 +575 4 42.524 2.38704 3.60859 -29.3388 -0.685173 -5.23931 +576 4 44.5714 0.285197 1.65031 -2.2735 9.46305 -11.1841 +577 4 43.1006 41.7553 2.65834 21.2852 6.7215 -5.00379 +578 4 44.7366 41.0658 2.93547 0.768749 11.7185 9.28335 +579 4 44.5004 3.68719 1.60884 14.6444 -0.878149 -7.94907 +580 4 42.7371 3.8089 1.73084 7.8177 -0.664582 -10.9353 +581 4 43.3892 2.25631 1.16493 5.07933 -5.28874 -15.8541 +582 1 44.0858 40.4147 5.76991 -7.82686 10.7063 0.0613705 +583 2 44.6952 39.2248 6.26612 46.8291 -49.1328 2.55503 +584 2 45.6273 38.4983 5.15014 -10.8203 -24.5871 -10.3389 +585 3 45.1671 38.1033 4.04814 1.93862 22.6196 32.2907 +586 4 45.3114 39.4262 7.20071 -5.62912 7.00222 -16.0196 +587 2 43.5561 38.2867 6.74046 -22.632 -0.869913 -14.9675 +588 2 42.367 38.8131 5.80069 8.99216 14.1028 58.1483 +589 2 42.6345 40.3137 5.92605 0.476166 33.3948 28.8915 +590 4 43.357 38.4284 7.8368 -6.62566 13.9326 -12.0425 +591 4 43.8048 37.1922 6.7609 -3.60965 9.48681 -21.6917 +592 4 41.3136 38.6254 6.13023 8.266 -9.51845 1.65532 +593 4 42.4187 38.6156 4.74928 6.70678 -23.3061 -29.6074 +594 4 42.2773 40.816 6.98347 15.1971 -23.3227 -46.4987 +595 4 42.1119 40.8277 5.08767 -3.55372 4.4917 2.49103 +596 1 46.8487 37.9967 5.55394 17.2019 12.2692 25.006 +597 2 47.7247 37.0178 4.87762 -6.21972 -16.2302 -28.9734 +598 2 47.0354 35.8358 4.10675 -5.54108 30.4574 49.2069 +599 3 47.4638 35.4602 3.01706 -3.2731 6.26074 0.626287 +600 4 48.411 37.4477 4.12082 -11.0175 18.1135 -5.68521 +601 2 48.6499 36.5231 5.98749 -16.6595 -15.0747 15.7963 +602 2 48.891 37.7945 6.79307 0.637735 -25.9659 35.4869 +603 2 47.512 38.4108 6.81936 -6.06228 0.364124 -35.7901 +604 4 49.55 36.0027 5.64818 14.2665 0.926908 -8.4052 +605 4 48.1323 35.7432 6.6035 -1.04051 5.39171 0.916503 +606 4 49.6303 38.4539 6.33816 11.9938 9.28906 -4.17289 +607 4 49.2156 37.5316 7.87598 -0.828426 8.45001 -24.626 +608 4 47.6223 39.5002 6.92189 -5.61966 10.135 -2.25063 +609 4 46.9349 38.0418 7.65693 -11.0214 -6.34351 22.8142 +610 1 45.9811 35.3016 4.79343 19.1712 31.3513 11.165 +611 2 45.3118 34.1769 4.28537 -21.2148 -46.3229 -17.5718 +612 2 44.4751 34.4561 3.06273 -18.3812 8.00009 -33.6438 +613 3 44.391 33.6426 2.09905 3.94034 16.0457 30.0851 +614 4 45.6176 35.6832 5.71813 13.2063 -8.66839 -22.6288 +615 4 46.0373 33.4799 3.80083 11.0255 -0.404913 12.3267 +616 2 44.604 33.4055 5.40679 37.9095 -5.49339 -20.8443 +617 2 43.894 32.1911 4.95963 4.52806 -52.0805 -10.2655 +618 3 42.6666 32.0496 5.30411 26.1406 -7.63566 -17.5185 +619 3 44.6473 31.2926 4.419 -30.7677 19.4747 14.2469 +620 4 43.8381 33.9821 5.82617 -35.1808 40.951 30.2942 +621 4 45.3664 33.1691 6.19311 -10.275 -1.0365 4.4818 +622 1 43.9409 35.7078 2.94042 3.22733 -51.5357 -49.9186 +623 2 43.348 36.2006 1.70588 25.8776 -9.12573 -18.8138 +624 2 44.3757 36.8172 0.713167 -7.64912 -13.2689 38.6134 +625 3 44.0628 36.9589 41.4508 -2.41529 3.02373 -15.0868 +626 4 43.9087 36.323 3.69682 4.46748 41.5024 48.5675 +627 4 43.0059 35.3045 1.0879 -7.34341 13.0696 15.3539 +628 2 42.2218 37.2049 1.98307 -32.8685 -0.904888 11.5727 +629 2 41.1062 36.5938 2.90711 22.5622 20.6064 -2.77479 +630 2 39.8757 37.4913 2.92488 9.99264 -5.47282 62.3883 +631 3 39.5847 37.9927 4.02645 -6.88693 1.84466 -13.34 +632 1 39.0832 37.5519 1.86835 -2.09978 -20.426 -31.5908 +633 4 41.7044 37.4782 1.02484 10.2081 4.13789 1.30545 +634 4 42.5649 38.1527 2.49808 3.34998 -7.04672 -12.996 +635 4 41.496 36.4873 3.97615 -8.32458 2.86238 -16.0656 +636 4 40.817 35.592 2.59085 -6.50381 -15.3028 -7.15704 +637 4 39.3467 37.1489 0.943045 -1.18671 2.30285 11.2704 +638 4 38.1024 37.7997 2.00291 -4.61511 13.1634 -1.5169 +639 1 45.5865 37.1913 1.18701 0.34656 3.48246 -50.9957 +640 2 46.5715 37.7193 0.263736 40.0587 13.4866 27.3297 +641 2 47.1476 36.6709 41.2495 -9.99518 -39.8037 -22.9547 +642 3 47.6611 35.6473 41.7682 -3.12622 19.3551 -24.5438 +643 4 45.9505 37.0475 2.10099 0.0710674 -6.02767 36.3056 +644 4 46.0766 38.4733 41.5789 -9.05589 19.6465 -18.4972 +645 2 47.8462 38.4064 1.04164 -24.5048 14.2529 -26.5929 +646 2 47.4036 39.6651 1.82888 -3.7708 6.53308 31.1421 +647 2 48.5926 40.4064 2.51341 13.2626 3.99863 -2.76696 +648 3 49.7104 40.5691 1.98441 -24.6046 -10.5895 -1.86534 +649 1 48.3407 40.8898 3.74779 29.4138 -3.81739 16.8938 +650 4 48.597 38.7482 0.246377 -8.81496 -5.86425 14.2737 +651 4 48.3893 37.7509 1.72975 1.66752 -15.4435 3.74234 +652 4 46.6019 39.4971 2.66308 23.3117 -7.11271 -27.0857 +653 4 46.9261 40.3559 1.12913 -3.21242 13.4997 -7.95635 +654 4 47.3907 40.9351 4.12169 -5.60594 2.69026 7.41827 +655 4 49.1659 41.1473 4.37984 -25.8317 -2.18268 -20.985 +656 1 47.0143 36.8241 39.8589 2.94896 -6.17569 33.9376 +657 2 47.6738 36.0506 38.8108 16.6825 -23.5637 34.6067 +658 2 48.454 37.0258 37.9695 9.24498 -19.2444 17.2828 +659 3 47.9734 37.5867 37.0249 -16.9661 22.5794 -32.933 +660 4 46.3407 37.4883 39.4677 -2.13376 9.43233 0.449621 +661 4 48.4374 35.3321 39.3605 -24.6855 17.1776 -23.0678 +662 2 46.6968 35.2528 37.909 -27.9143 -33.2437 25.7199 +663 2 46.039 33.9895 38.7043 9.93401 10.5983 7.56799 +664 2 46.87 32.6784 38.9289 23.0786 -0.450758 -24.5995 +665 1 47.7656 32.5928 40.0651 -0.0346617 67.7235 50.2506 +666 2 48.5337 31.5574 40.3699 -14.5633 -26.8579 -35.9878 +667 1 48.7282 30.552 39.4879 -2.05986 8.25564 18.106 +668 1 48.8872 31.3858 41.6213 -4.84512 27.348 -3.11289 +669 4 47.2327 34.8627 37.0058 -5.81127 5.13112 -1.60937 +670 4 45.8267 35.9464 37.6192 18.3744 -10.9215 -5.83414 +671 4 45.065 33.6697 38.178 15.3305 12.1509 10.6411 +672 4 45.8045 34.3704 39.7428 -14.1926 -3.74807 -10.9265 +673 4 47.5159 32.4832 38.0006 -21.4463 1.51143 8.96621 +674 4 46.1858 31.8178 39.0967 -9.12823 -0.449275 -15.1225 +675 4 47.7485 33.3794 40.8208 -8.02877 -26.8637 -33.9869 +676 4 48.3609 30.5297 38.5261 -2.43008 2.66571 1.08755 +677 4 49.1746 29.6933 39.8011 5.57148 -11.3344 1.43527 +678 4 48.5595 32.0107 0.447997 -4.49593 6.14729 8.57279 +679 4 49.3675 30.5632 41.8859 20.5825 -37.41 17.1512 +680 1 49.6971 37.2567 38.3612 38.8031 36.8466 -19.9315 +681 2 50.6251 38.1764 37.6375 5.59701 -6.58181 11.8605 +682 2 51.1059 37.476 36.33 -5.39593 -3.52342 3.95062 +683 3 51.4567 36.2851 36.3473 -6.1727 9.88097 2.62067 +684 4 50.1666 36.6257 38.9842 10.5469 -17.0261 18.2142 +685 4 50.0436 39.1015 37.4003 1.48542 -2.85918 -9.88003 +686 2 51.8783 38.6033 38.5414 -14.1699 17.2606 4.5582 +687 2 51.4771 39.4948 39.8067 23.634 -8.13025 9.13717 +688 2 52.8025 39.6936 40.6861 -45.72 0.0787629 30.9804 +689 2 51.0312 40.8873 39.3543 -1.21924 6.71403 17.5275 +690 4 52.6247 39.2003 37.9187 -12.0326 -10.2321 5.24388 +691 4 52.4336 37.7304 38.9418 -1.83231 -8.6555 -7.07863 +692 4 50.6844 38.9864 40.4458 6.67436 6.37453 -9.78056 +693 4 52.9275 38.7652 41.2899 1.57503 4.15297 5.5095 +694 4 52.875 40.6185 41.4124 -9.95772 -27.9304 -22.9777 +695 4 53.6477 39.6981 40.0479 39.2622 9.27083 -23.1198 +696 4 51.882 41.4315 38.8764 -8.78739 -1.58992 -12.4168 +697 4 50.8284 41.5065 40.2813 -10.0843 -5.65437 -12.2377 +698 4 50.1041 40.7893 38.7156 9.84678 12.7352 4.22225 +699 1 51.1335 38.2092 35.1872 23.4477 43.7196 -18.1994 +700 2 51.5372 37.7272 33.8205 5.66277 23.826 53.2621 +701 2 52.816 38.5373 33.39 -13.9696 27.2523 3.91394 +702 3 52.9014 39.7954 33.5824 -9.48934 -35.8428 -1.88315 +703 4 51.0917 39.2914 35.1751 -6.07189 -44.7564 8.7296 +704 4 51.807 36.6734 33.9114 3.67702 -17.8942 -3.77347 +705 2 50.2728 37.942 32.9627 24.5619 2.20768 -27.072 +706 2 49.0946 37.0552 33.3907 -40.4332 32.861 4.12747 +707 2 50.6582 37.6771 31.4819 -4.87136 -12.6088 -15.1928 +708 2 49.1924 35.592 33.2496 18.605 -47.1891 -10.6734 +709 4 50.0222 39.0181 33.0462 -10.0421 3.96713 0.824793 +710 4 48.1822 37.369 32.7965 11.3859 0.507389 5.43773 +711 4 48.766 37.227 34.4352 6.35082 10.8857 5.72377 +712 4 49.7261 37.457 30.8365 21.3715 9.42576 10.5226 +713 4 51.3528 36.7896 31.3856 -11.4398 6.26312 1.5823 +714 4 51.2274 38.5516 31.0485 -10.0605 -6.0953 1.35419 +715 4 50.1827 35.2313 33.6939 -19.2762 -1.86106 -7.31237 +716 4 49.1345 35.3223 32.1629 6.46074 -3.78635 4.92713 +717 4 48.3248 35.0641 33.7333 8.66481 1.90115 0.669024 +718 1 53.7674 37.8522 32.7049 -0.401058 29.0536 2.76503 +719 2 54.8534 38.494 31.9889 21.3589 25.2573 -50.7784 +720 2 0.070256 37.9331 30.5159 -12.6617 -10.513 26.1463 +721 3 0.610536 36.8336 30.3273 -13.153 9.14635 -3.0322 +722 4 53.7049 36.8532 32.6778 5.78014 -33.2974 -6.55066 +723 4 54.4976 39.583 31.7137 12.734 -24.0185 30.659 +724 2 1.32523 38.4582 32.6174 -11.2306 -14.0383 43.8112 +725 2 2.25298 39.4244 31.93 21.239 -3.52493 -6.53852 +726 2 1.82142 40.7594 31.946 9.01925 8.15494 1.3639 +727 2 3.55305 39.1373 31.3858 -52.1121 -37.4601 32.7366 +728 2 2.62719 41.7738 31.436 16.1375 42.966 -9.20235 +729 2 4.2717 40.1621 30.8907 55.019 31.5071 -38.7093 +730 2 3.8753 41.5182 30.8618 10.3374 -30.1635 6.5347 +731 4 1.72137 37.3957 32.6071 -2.968 13.2806 -7.3675 +732 4 1.36361 38.7573 33.7485 -10.0277 -6.08615 -32.1159 +733 4 0.900203 41.04 32.4671 -4.90014 4.47018 0.827909 +734 4 4.05865 38.1292 31.3848 -19.507 10.3261 2.47632 +735 4 2.40669 0.963664 31.507 -12.4107 -17.8541 2.52862 +736 4 5.22734 39.8163 30.4261 -2.17835 18.3508 4.41679 +737 4 4.61313 0.382875 30.4956 -18.9116 -9.53382 4.9162 +738 1 54.5208 38.7001 29.536 -17.794 9.59417 2.44526 +739 2 54.4433 38.3677 28.0932 0.413701 6.77287 11.8816 +740 2 53.8236 36.9714 27.8054 -10.5704 38.9519 24.3324 +741 3 54.2836 36.1684 27.0139 12.3723 -16.7122 -9.38408 +742 4 54.0063 39.582 29.8758 15.9225 -27.1932 -25.0825 +743 4 53.6617 39.0994 27.7122 21.1252 -9.31914 -10.5745 +744 2 0.84771 38.4562 27.3872 5.21129 26.4327 0.415045 +745 4 1.55752 39.2926 27.6564 -22.375 -0.429945 3.27523 +746 4 0.737328 38.5366 26.268 -0.662808 -7.52676 8.67249 +747 4 1.44048 37.5755 27.6711 3.3074 -14.1434 -6.0421 +748 1 52.6712 36.7812 28.4639 -34.4859 10.4254 42.9936 +749 2 51.8461 35.5981 28.5315 7.11639 -32.3641 19.2856 +750 2 52.1287 34.6607 29.761 72.1729 37.4894 -16.6197 +751 3 51.2969 33.8912 30.1393 -37.38 -39.1809 16.7772 +752 4 52.2301 37.5459 29.0797 18.7619 -22.9106 -24.882 +753 4 50.752 35.8045 28.6381 6.6344 10.4547 -3.03351 +754 4 51.9318 34.9661 27.6028 3.27123 7.03186 8.45077 +755 1 53.4041 34.6064 30.3039 -37.1524 -18.2668 23.7743 +756 2 53.8481 33.579 31.3343 19.9058 12.4048 -28.9308 +757 2 53.2753 33.7631 32.7245 -4.20442 17.2631 -10.7202 +758 3 53.3264 34.8931 33.2388 -7.00143 -11.8952 2.65621 +759 4 53.9984 35.4233 30.2821 14.046 11.4873 -9.55867 +760 4 53.5575 32.5679 30.9796 -2.97426 -3.20006 -4.3618 +761 2 0.441949 33.6673 31.397 15.483 24.485 -22.5221 +762 2 1.1159 33.1056 30.111 -2.52249 -22.0361 -11.2405 +763 2 2.65939 33.3504 30.0471 -29.7948 -11.8394 -36.8606 +764 2 3.5253 32.433 30.8659 3.71436 3.74322 35.9681 +765 1 4.92891 32.7835 30.8601 -3.73949 -14.6782 3.94495 +766 4 0.930008 33.1164 32.2052 -10.1795 -8.12889 21.2637 +767 4 0.820281 34.7554 31.5264 -17.1946 -20.5931 1.67355 +768 4 0.726808 33.5631 29.1693 -8.69229 5.5421 6.41341 +769 4 0.816642 32.0044 30.0112 14.0154 14.8269 0.94841 +770 4 2.76655 34.4177 30.2798 16.9839 11.3836 1.64388 +771 4 2.99027 33.2006 28.9712 -4.31169 8.16855 10.4317 +772 4 3.48024 31.3628 30.6286 -9.21502 -9.13385 -9.88849 +773 4 3.14214 32.5157 31.9169 10.307 -3.37241 -3.01155 +774 4 5.38024 32.7641 29.968 4.13535 -6.65161 -12.8027 +775 4 5.44585 32.16 31.4735 7.57437 4.94374 1.68638 +776 4 5.11721 33.7072 31.1652 -0.520286 24.3887 13.7994 +777 1 52.7286 32.6609 33.3217 21.3895 7.82715 -40.48 +778 2 52.3746 32.6765 34.6845 -3.94215 -5.7204 42.1903 +779 2 53.6544 32.9612 35.4718 -32.0777 16.7216 -3.31611 +780 3 54.7101 32.4293 35.2196 26.5529 -12.799 -1.69002 +781 4 52.7346 31.7402 32.8358 -3.66087 10.5856 2.03104 +782 4 51.6553 33.4893 34.886 -4.93781 11.2662 -7.45083 +783 2 51.7389 31.3462 35.1425 36.1525 -8.24878 -2.45066 +784 2 50.4549 31.4357 35.902 -2.56298 9.46411 57.003 +785 2 50.5914 31.9702 37.3969 -4.77582 -10.2539 -35.2763 +786 3 49.9129 32.941 37.7385 4.53321 10.1718 7.36032 +787 1 51.4448 31.3274 38.2318 1.89331 10.2207 20.9211 +788 4 52.4532 30.7011 35.7138 0.934865 4.72627 -2.3237 +789 4 51.5619 30.7887 34.2312 -11.1921 -21.1455 -14.7508 +790 4 50.0197 30.4197 36.0127 -8.03636 -0.273264 -6.56567 +791 4 49.7685 32.1089 35.3545 -11.9583 -2.57651 0.31815 +792 4 51.7323 30.3416 38.1022 2.22495 5.18328 -8.30147 +793 4 51.645 31.7871 39.1631 -4.2657 -12.8631 -21.1898 +794 1 53.54 33.8952 36.4131 -39.2018 -0.531466 -0.79929 +795 2 54.5682 34.2648 37.3102 -29.3437 58.7358 21.9421 +796 2 54.3255 33.5954 38.6431 29.6978 -77.406 0.637438 +797 3 53.3742 33.7807 39.3881 -15.8118 22.9548 5.85491 +798 4 52.6165 34.3686 36.5483 14.9252 -1.63515 2.31459 +799 4 0.525104 33.9954 36.8979 32.3496 -27.0675 -4.05845 +800 2 54.6285 35.827 37.4074 -17.7645 -17.3983 39.0191 +801 2 0.013954 36.4546 36.058 15.6745 -1.04323 18.583 +802 2 0.049019 37.9526 36.293 -63.1087 6.90888 -39.4544 +803 2 1.42802 35.9308 35.6826 4.08802 -6.56861 34.108 +804 4 0.435555 35.9801 38.2063 -13.4425 16.5914 -13.2273 +805 4 53.6198 36.2963 37.798 28.292 -21.2068 -7.80607 +806 4 54.2061 36.2134 35.3084 7.36084 -1.04605 -3.46995 +807 4 54.0713 38.2397 36.8522 27.1057 4.55429 -9.55418 +808 4 54.939 38.4282 35.2643 6.0019 1.58695 18.2366 +809 4 0.927863 38.3313 36.762 28.685 14.2218 21.5028 +810 4 1.30489 34.8989 35.3991 1.43296 -22.664 -21.4406 +811 4 2.25694 35.8344 36.4845 -24.5016 17.8738 -12.6534 +812 4 1.83634 36.4362 34.8335 13.635 15.7788 -26.8996 +813 1 0.008587 32.3758 38.733 13.7846 27.3237 -75.0314 +814 2 54.826 31.3 39.6331 17.4428 -14.6066 45.4768 +815 2 0.455793 31.7866 40.9725 -5.37526 1.66294 14.9859 +816 3 1.60943 32.1773 41.0547 11.2247 3.92934 -7.13086 +817 4 0.661532 32.0877 37.9163 -19.8505 19.9989 33.4434 +818 4 53.7452 31.1425 39.875 0.374502 -5.35979 -15.722 +819 2 0.574437 30.0043 39.0439 11.2157 23.6116 11.9724 +820 2 0.334302 28.7136 39.8578 -22.6665 -11.1233 -21.4622 +821 2 0.695999 28.7 41.3625 12.0844 -36.9796 9.0265 +822 3 54.7253 28.727 0.298109 10.889 15.3071 -4.11946 +823 3 1.91063 28.4506 41.7261 -30.7481 15.8042 -10.4483 +824 4 1.71086 30.1341 39.082 -19.7243 9.32222 0.312381 +825 4 0.358791 29.9926 37.9166 -2.62684 -19.8589 21.79 +826 4 0.882365 27.912 39.2891 -0.232785 0.308618 14.1734 +827 4 54.2301 28.3798 39.7718 17.2545 10.1943 -0.206185 +828 1 54.6325 31.7916 0.156881 38.5875 2.07504 -29.8841 +829 2 54.8631 32.3302 1.45975 7.41407 33.4343 26.7616 +830 2 1.21087 32.0241 2.20189 -33.1211 2.89979 -4.9396 +831 3 1.57835 32.811 3.08735 12.0797 -3.2377 -11.0832 +832 4 53.6756 31.6317 41.8616 -38.5912 -7.03962 0.740029 +833 4 54.9627 33.4927 1.3754 -11.7864 -35.033 -4.32612 +834 2 53.6666 32.0355 2.42828 -17.6969 8.95863 -1.18459 +835 2 52.1933 32.3158 2.0402 15.1012 41.0915 -15.9482 +836 3 51.3911 33.0513 2.74715 36.5037 -34.5123 -13.5772 +837 3 51.9207 32.0348 0.835441 -22.1157 -3.97518 6.29873 +838 4 53.9089 32.5595 3.33158 -2.01457 20.6007 30.7692 +839 4 53.6609 31.0051 2.75768 6.68313 -26.6133 3.27231 +840 1 1.77413 30.8239 1.99288 23.346 -11.0551 12.4557 +841 2 2.99412 30.3649 2.70859 20.7873 20.7026 2.58588 +842 2 4.37767 30.5585 1.9432 -4.58172 12.4342 76.2013 +843 3 5.43315 30.6356 2.6242 -17.4542 -1.84538 -14.1099 +844 4 1.23141 30.1158 1.49013 8.16278 -4.42375 -5.05013 +845 4 3.08709 30.9756 3.71749 -2.54673 -19.312 -31.0286 +846 4 2.99418 29.2776 2.99437 -11.6108 14.2547 -3.21828 +847 1 4.33484 30.73 0.643592 -44.4777 10.1896 -41.2897 +848 2 5.29878 31.2923 41.6537 25.3276 0.744315 3.96016 +849 2 5.54544 32.7486 0.121481 37.2819 -30.872 -27.7426 +850 3 4.68176 33.387 0.67546 -18.5336 28.2868 17.8008 +851 4 3.3891 30.7154 0.224796 5.58966 -1.49205 -0.51948 +852 4 6.30256 30.8588 41.8823 -3.47112 -15.4387 -8.82901 +853 2 4.8423 31.1802 40.1578 47.5835 -21.6785 -9.15502 +854 2 4.71332 29.7742 39.4637 -7.18766 34.2596 -8.85866 +855 2 5.63064 28.6968 40.0034 1.34917 -52.5839 -25.1875 +856 1 5.28494 28.1736 41.3081 -3.70672 3.58414 23.7744 +857 2 6.07557 28.0057 0.492928 -10.4577 4.69864 -29.3733 +858 1 7.37832 28.2278 0.392183 22.9004 -4.79637 26.256 +859 1 5.53705 27.6868 1.66636 -6.4094 -24.443 39.9026 +860 4 5.53303 31.787 39.5095 -0.196101 -2.7377 7.98036 +861 4 3.92152 31.7024 40.0755 -40.4143 20.5365 -6.7059 +862 4 4.89215 29.8961 38.3273 -2.53464 -0.592337 23.8175 +863 4 3.64677 29.4833 39.5295 -2.27017 -8.63927 2.61329 +864 4 6.69627 28.939 39.9328 9.42975 10.3347 -2.35439 +865 4 5.48992 27.7969 39.2806 7.04825 21.6687 20.0754 +866 4 4.27254 28.0467 41.4152 -4.83075 -3.28587 3.65899 +867 4 7.98538 28.2099 41.4852 -8.02405 3.18538 -21.0185 +868 4 7.94047 28.2423 1.24565 0.364194 -0.98827 11.7246 +869 4 4.53186 27.4078 1.78766 14.7644 10.3007 -8.4097 +870 4 6.1013 27.52 2.55737 -8.44391 7.70178 -27.0297 +871 1 6.79596 33.2006 41.6804 -27.9344 8.59735 4.57792 +872 2 7.15148 34.5952 41.8655 -38.9276 -12.1291 -1.68573 +873 2 6.77215 35.2911 40.5652 14.0197 56.9428 51.8707 +874 3 6.49158 34.715 39.5569 -13.5951 -21.5425 -43.0675 +875 4 7.31858 32.7386 40.9072 -2.655 4.76346 14.1821 +876 4 6.52583 35.0505 0.829338 19.3934 -10.3795 -24.0216 +877 2 8.63545 34.7883 0.159249 -4.7809 22.3707 74.7553 +878 3 9.31911 34.1951 41.0459 32.4158 -10.9375 -20.7672 +879 2 9.12239 34.1481 1.54228 -45.3508 12.3646 -39.5443 +880 4 8.86138 35.9031 0.177513 1.59938 -13.4643 1.18346 +881 4 10.1943 34.4871 41.2598 15.0836 -7.29109 -20.5697 +882 4 10.1218 34.4779 1.7295 32.9793 8.82002 13.7556 +883 4 9.1354 33.0404 1.45915 -3.89828 -1.77159 7.54964 +884 4 8.44695 34.5279 2.36236 9.39315 -9.78399 0.0431608 +885 1 6.96309 36.6454 40.6555 -22.2962 -38.3404 -33.8498 +886 2 6.94214 37.5275 39.5132 -15.3576 22.9899 27.1878 +887 2 8.03225 37.1821 38.5547 25.8315 2.87875 -39.3086 +888 3 7.87409 37.2091 37.3037 -11.7489 -2.94068 30.2829 +889 4 7.09017 37.0079 41.5812 4.58243 22.402 24.7274 +890 4 6.01646 37.4072 38.9238 -6.0018 -8.28766 -1.15408 +891 2 7.01182 39.0163 40.0252 -15.3603 -23.3284 55.3652 +892 2 5.61926 39.5384 40.7634 13.0639 11.727 -14.3013 +893 2 5.74741 41.0778 41.0735 34.612 -8.65688 -61.1535 +894 2 4.30485 39.278 39.9775 33.2171 6.29002 -24.4772 +895 4 7.23253 39.6079 39.1676 9.01238 29.648 -28.6912 +896 4 7.91826 39.1206 40.7867 -28.368 0.120823 -25.2036 +897 4 5.4532 38.9933 41.7239 13.5286 -1.18368 4.70417 +898 4 4.88701 41.4539 41.5866 -22.2749 9.39049 21.0562 +899 4 5.89633 41.7578 40.1185 -8.19165 -26.548 25.276 +900 4 6.67066 41.2365 41.6556 -0.494064 4.57358 11.7906 +901 4 4.18164 39.8273 38.9933 8.48456 -7.17755 11.4037 +902 4 3.44244 39.5261 40.5797 -17.807 1.17877 7.97341 +903 4 4.2824 38.1939 39.7929 -10.4691 -3.8299 -8.01616 +904 1 9.23783 36.8543 39.0653 -4.40645 21.0053 19.4908 +905 2 10.3275 36.5838 38.1582 31.0816 -25.3995 62.8998 +906 2 10.2997 35.2224 37.4613 6.04581 38.1949 -0.210763 +907 3 11.0208 35.1071 36.4655 -6.3656 -14.3958 -11.0193 +908 4 9.51333 37.1441 40.0706 -14.9717 -14.5173 -38.8343 +909 4 10.386 37.3498 37.3821 -1.67567 12.3369 -13.0834 +910 2 11.6168 36.6846 39.0604 -5.3878 -32.5356 -23.0633 +911 3 11.6818 35.7254 40.0985 -18.2206 13.507 16.8431 +912 4 11.7318 37.6647 39.5052 6.99822 20.9023 2.76215 +913 4 12.4798 36.426 38.4299 12.1644 16.7594 -11.1747 +914 4 12.2479 35.0511 39.7675 10.0745 -20.8981 -3.76732 +915 1 9.3909 34.3264 37.8733 -42.427 -15.3638 26.6935 +916 2 8.99216 33.1557 37.0842 54.1918 17.4661 1.85655 +917 2 8.44195 33.5842 35.7305 -20.833 60.571 55.2199 +918 3 8.45395 32.8337 34.8033 7.91235 -41.3122 -40.5547 +919 4 8.901 34.4208 38.8182 18.72 -3.57692 -25.7233 +920 4 10.0039 32.69 36.8915 -15.1884 -12.4868 -9.34361 +921 2 8.05349 32.1507 37.7268 -1.844 -26.1592 7.76215 +922 2 8.63612 31.2276 38.7905 8.98886 15.2457 3.52798 +923 3 8.28567 31.4376 39.9878 9.18033 -14.5703 -9.08999 +924 3 9.46172 30.3301 38.4185 -14.4281 10.7169 -2.66077 +925 4 7.57008 31.4717 36.9797 -4.32683 11.3708 2.99534 +926 4 7.24557 32.7088 38.1955 -18.7592 7.98312 4.87833 +927 1 7.76821 34.7903 35.7104 -0.921577 -49.5867 -7.77983 +928 2 7.00589 35.2713 34.5947 28.4194 33.7396 -49.4054 +929 2 7.85162 36.3274 33.7967 14.0615 10.3677 50.876 +930 3 7.59561 36.677 32.642 -11.5138 -12.0529 -0.0837023 +931 4 7.64044 35.3156 36.5601 -2.79577 12.0246 16.4277 +932 4 6.95142 34.464 33.8059 -8.74679 1.13416 10.6726 +933 2 5.60472 35.8897 34.9384 -10.82 -34.5279 -29.2679 +934 2 4.80808 34.6511 35.4252 21.4048 19.1212 -24.4535 +935 2 4.58939 34.449 36.7896 -8.79739 7.49237 6.99756 +936 2 4.44707 33.6361 34.4808 -22.1156 13.6667 13.0483 +937 2 3.78406 33.375 37.155 10.056 16.8174 60.0349 +938 2 3.57928 32.5992 34.8543 35.6828 20.067 14.4288 +939 2 3.32606 32.5122 36.2195 -36.4887 -32.5961 -12.2866 +940 3 2.43989 31.6229 36.7148 -5.7594 -17.052 -20.0699 +941 4 5.14192 36.3424 33.9886 5.39246 -18.3577 14.2305 +942 4 5.60606 36.7583 35.5989 7.01287 1.52307 19.367 +943 4 4.94491 35.1783 37.5598 -4.47364 -7.92921 -7.91861 +944 4 4.66046 33.7427 33.4202 4.87397 4.4658 -8.40916 +945 4 3.45738 33.1597 38.2449 15.2806 17.1295 -26.8514 +946 4 3.26795 31.828 34.148 -6.61111 -3.61155 -4.72788 +947 4 2.1868 31.1622 35.9134 -6.91994 -9.03483 11.406 +948 1 8.90205 36.8981 34.5027 -17.2687 17.5401 -60.9896 +949 2 9.70361 38.0134 33.9387 24.2231 -52.0812 37.3823 +950 2 8.8546 39.1711 33.5701 14.7092 18.0593 -4.53516 +951 3 9.06515 39.7643 32.526 6.45085 3.58457 -7.26619 +952 4 9.11675 36.6435 35.4518 3.62665 -3.0608 21.1339 +953 4 10.3861 38.3235 34.818 -10.2978 3.44266 -21.7419 +954 2 10.5787 37.5562 32.7307 -21.6135 -30.8037 4.74181 +955 2 11.6892 38.5091 32.4223 15.379 -13.1594 38.9153 +956 3 11.683 39.1804 31.4042 4.19267 20.0472 -18.4805 +957 1 12.6852 38.53 33.3751 41.3863 26.0224 -13.8263 +958 4 9.85905 37.4261 31.8504 20.0453 2.40541 7.8736 +959 4 11.053 36.5467 32.9319 -7.17885 8.97611 -4.2567 +960 4 12.817 37.8369 34.166 -15.4043 12.1891 -16.4176 +961 4 13.5001 39.2408 33.2564 -39.0039 -25.8302 4.81098 +962 1 7.96197 39.5631 34.4599 -33.9246 23.5433 37.1278 +963 2 7.21007 40.8276 34.5568 -18.3646 -15.2096 -14.7898 +964 2 8.22007 41.896 34.9201 0.758716 14.3361 -6.26955 +965 3 8.97663 41.7874 35.871 13.0919 -8.40756 13.8683 +966 4 7.83943 39.0508 35.3409 8.95409 -9.59767 0.690263 +967 4 6.70734 41.0591 33.5261 17.9743 -2.28149 22.8597 +968 2 6.0301 40.6247 35.6674 21.3841 11.5647 -11.8815 +969 2 4.89974 39.9794 34.8247 17.8968 2.41192 -27.2216 +970 2 5.64567 41.9074 36.4174 -5.31946 16.9228 -22.0167 +971 2 3.85064 39.271 35.6143 -7.9417 -14.8054 48.1955 +972 4 6.41951 40.0018 36.4929 2.02391 -20.04 -2.41117 +973 4 5.36435 39.2019 34.126 -8.73918 7.93575 11.5905 +974 4 4.48342 40.7424 34.1094 -6.00744 -5.42447 8.5897 +975 4 5.00487 41.8434 37.3074 -11.5574 -14.3762 1.01334 +976 4 5.12929 0.689353 35.6946 7.17582 1.37977 8.89479 +977 4 6.56067 0.460605 36.8355 2.18467 8.54142 -3.2903 +978 4 3.23423 39.9796 36.2601 8.91814 -10.815 -11.4927 +979 4 4.38489 38.5352 36.333 -17.3309 14.265 -14.1697 +980 4 3.16246 38.6765 34.9814 -1.3822 0.0882741 -1.23744 +981 1 8.27901 1.09677 34.1745 -17.8694 -35.8502 15.8719 +982 2 9.1495 2.17731 34.4611 25.5007 24.1899 -15.5427 +983 2 8.44305 3.45517 34.8181 7.33507 13.3767 -14.0082 +984 3 7.22584 3.58853 34.5952 14.73 6.44535 13.4701 +985 4 7.64387 1.07834 33.3925 -5.10967 17.8437 -25.4682 +986 4 9.72616 1.98981 35.3795 6.67437 -11.367 8.50474 +987 2 10.1416 2.3939 33.2727 7.80857 1.28792 -5.65283 +988 2 11.1754 1.27875 33.0535 -29.5709 -1.62172 8.74553 +989 2 12.298 1.25902 34.0434 45.8123 -20.4226 -15.8942 +990 3 13.4264 1.60062 33.6211 -9.09849 2.20405 14.6225 +991 1 12.1286 0.499484 35.1615 13.5856 38.0862 1.93866 +992 4 10.7117 3.33658 33.4062 0.0269402 1.80508 0.780117 +993 4 9.62868 2.54332 32.3022 -11.3844 1.67988 3.84081 +994 4 11.6026 1.39089 32.0291 1.1132 -6.32648 1.88738 +995 4 10.6463 0.304077 33.1517 4.80745 -4.48978 -13.057 +996 4 11.1623 0.324257 35.4356 -7.1112 -9.24345 12.7946 +997 4 12.86 0.645961 35.8984 -11.3978 -13.87 -11.7385 +998 1 9.29061 4.442 35.2624 -22.3208 40.9019 24.8252 +999 2 8.81116 5.82611 35.6978 -18.3987 -9.60009 -41.1421 +1000 2 7.90959 6.36535 34.5148 35.1086 -14.4229 -13.6713 +1001 3 8.27789 6.14754 33.3333 -13.6173 9.04219 21.6414 +1002 4 10.326 4.35425 35.3433 -15.5473 -10.8229 -5.10085 +1003 4 8.07437 5.70026 36.5174 9.02025 -1.47766 10.124 +1004 2 9.99583 6.76313 36.1565 -25.1565 20.6308 -28.9867 +1005 2 11.135 6.93617 35.1361 2.62363 -10.5046 6.46017 +1006 2 12.4502 7.42969 35.8581 -25.4448 -27.2564 -27.4451 +1007 2 12.3858 8.85842 36.3442 -55.084 26.5775 24.6628 +1008 1 13.634 9.41318 36.7712 33.8844 -44.8334 11.878 +1009 4 10.2929 6.30703 37.0832 24.0012 -1.96783 25.2264 +1010 4 9.73373 7.84957 36.4159 -14.1304 -26.7275 0.147522 +1011 4 10.8081 7.68154 34.3572 5.16283 -4.02502 4.78839 +1012 4 11.298 5.9636 34.5725 5.23915 16.0099 8.41141 +1013 4 13.159 7.4137 35.035 25.5516 -2.14082 -10.0364 +1014 4 12.8083 6.68649 36.6117 -1.06896 6.08822 -0.205097 +1015 4 11.642 8.94716 37.2538 22.1051 -1.45756 -27.4817 +1016 4 11.9592 9.50431 35.5025 9.97141 -3.64215 15.7788 +1017 4 13.6538 10.3723 37.0555 -8.09423 13.3796 3.79584 +1018 4 14.2885 9.3339 36.0056 2.60625 13.8446 -5.44478 +1019 4 14.0928 8.83644 37.5176 -15.06 24.3666 -13.6607 +1020 1 6.73429 6.959 34.8261 9.36917 -0.537504 -3.37326 +1021 2 5.68914 7.48312 33.9811 -11.6093 0.198368 -29.7566 +1022 2 4.72257 6.43001 33.3633 23.9678 57.8121 29.6097 +1023 3 3.69345 6.80336 32.8731 -41.5354 18.269 -25.9458 +1024 4 6.5403 7.08067 35.8075 -8.4584 6.57489 23.7637 +1025 4 4.95828 8.08289 34.6274 18.5559 -1.63885 -10.0577 +1026 2 6.30301 8.33887 32.7628 1.61604 -0.894199 46.3222 +1027 2 6.96232 9.68302 33.2113 17.5203 -12.0258 -13.4607 +1028 2 6.11334 10.8061 33.8152 -7.60378 12.6352 19.0416 +1029 3 5.31496 11.4419 33.0422 10.0378 -5.26853 5.86857 +1030 3 6.28181 11.1536 35.05 3.36103 -18.7342 -31.8229 +1031 4 5.5011 8.60814 32.0808 -13.4162 -1.3456 -15.0867 +1032 4 7.01778 7.64283 32.2215 -8.51236 18.4517 -1.11608 +1033 4 7.483 10.1113 32.3225 -5.01151 2.49106 -4.14977 +1034 4 7.84021 9.44334 33.8428 -3.17944 -2.15711 8.7111 +1035 1 4.98957 5.17145 33.408 31.7294 -73.5208 5.3031 +1036 2 4.03057 4.12888 32.9492 20.6717 -14.7005 -20.2168 +1037 2 2.6598 4.36206 33.592 -3.0444 -3.65398 -36.823 +1038 3 2.63368 4.6245 34.7729 -17.9957 9.5377 28.5993 +1039 4 5.93287 4.88555 33.7778 -25.4301 -4.21673 -10.3446 +1040 4 3.97065 4.08898 31.7849 -0.621936 10.7688 28.6704 +1041 2 4.54797 2.73693 33.4323 -9.78314 13.2989 35.3654 +1042 3 5.7396 2.38581 32.8061 3.87836 -1.00687 -28.9834 +1043 4 3.83029 1.94659 33.1597 -9.96533 -6.0451 7.8725 +1044 4 4.7579 2.77573 34.5879 -14.8326 -6.64015 -28.538 +1045 4 6.39905 2.57303 33.4496 16.1931 5.10903 8.49462 +1046 1 1.55493 4.20465 32.7937 9.73391 7.12296 -2.26043 +1047 2 0.143907 4.28394 33.2313 13.768 -18.1657 13.0528 +1048 2 54.6863 2.83094 33.3214 -0.0746788 -18.1404 42.9803 +1049 3 54.7972 2.04898 32.3833 -5.36381 -6.57018 -20.4337 +1050 4 1.75536 3.84626 31.8337 -17.5999 5.97734 12.9737 +1051 4 0.145346 4.72929 34.2869 -5.52407 -1.41906 -16.7638 +1052 2 54.0936 4.99047 32.3072 48.5491 53.4262 27.9832 +1053 3 54.4431 6.39026 32.3568 26.5828 -36.1107 8.98461 +1054 2 52.7233 5.01429 32.8691 -55.1486 3.23885 2.70228 +1055 4 54.1505 4.66496 31.2868 0.0550865 -16.0071 -29.7017 +1056 4 53.7986 6.85268 31.88 -20.6445 25.8891 -20.893 +1057 4 52.6197 5.54793 33.8322 5.93951 -5.3567 9.34144 +1058 4 52.3467 3.98503 32.9647 -9.06602 -5.34833 4.63236 +1059 4 51.9747 5.55452 32.2255 9.49609 -7.51028 -3.22615 +1060 1 54.1802 2.39741 34.5222 -14.8232 32.9081 27.5353 +1061 2 53.4465 1.14651 34.785 33.9277 15.1 -62.0226 +1062 2 52 1.44639 34.4384 -40.9452 -8.29472 -14.3346 +1063 3 51.516 2.52365 34.8247 -1.26544 -9.47139 -8.9244 +1064 4 54.0715 3.07846 35.3501 9.6448 -17.4772 -31.2652 +1065 4 53.9076 0.391021 34.1043 -10.2836 -7.20705 -0.475865 +1066 2 53.6069 0.737389 36.2058 40.6624 3.41232 47.0409 +1067 2 0.15698 0.778637 36.8849 -22.9225 14.5477 7.59965 +1068 2 0.184063 0.045177 38.2545 -1.48959 -18.0819 6.68284 +1069 2 1.19764 0.213126 35.924 -17.0247 17.4527 -16.4279 +1070 4 53.1759 41.6554 36.3315 -4.28574 -19.6707 2.88188 +1071 4 52.9166 1.40322 36.7387 0.80484 4.57892 22.2756 +1072 4 0.570353 1.84035 37.1024 -27.1105 -11.6335 -5.02718 +1073 4 54.3756 0.329349 38.9832 1.77724 8.98271 -8.45905 +1074 4 1.16626 0.241414 38.7954 -11.8595 -7.79047 -8.4361 +1075 4 0.0237 40.841 38.1265 8.8292 11.305 -0.869273 +1076 4 2.1582 0.044818 36.439 11.171 3.86438 -4.7836 +1077 4 1.22244 1.0066 35.1406 25.1303 -1.4606 -0.0516333 +1078 4 0.965216 41.2564 35.3038 -8.75588 -20.9773 6.66787 +1079 1 51.2089 0.49816 33.7614 57.6433 8.13256 28.0245 +1080 2 49.794 0.627079 33.5149 3.58551 37.6409 23.5907 +1081 2 49.1504 41.7362 34.5845 -39.3958 -31.0429 53.6988 +1082 3 49.3072 40.5133 34.7023 12.9245 12.8492 -11.6005 +1083 4 51.5663 41.4343 33.8516 -6.054 3.49016 -14.1934 +1084 4 49.5236 1.72635 33.6347 -1.89472 -11.9516 -1.26615 +1085 2 49.2899 0.093076 32.2111 -20.0469 10.239 -57.1496 +1086 2 49.5504 1.0758 31.0546 44.1484 5.96661 -35.419 +1087 1 48.7105 2.02971 30.4517 -2.34523 -25.3315 39.2373 +1088 2 50.7977 1.22066 30.3277 -75.7848 7.88288 4.96893 +1089 2 49.299 2.59293 29.3763 -23.865 8.39496 11.0232 +1090 1 50.5677 2.14293 29.3127 -12.36 -15.4034 27.3398 +1091 4 48.1533 41.8436 32.187 18.4481 1.21563 9.00361 +1092 4 49.725 40.9798 32.0543 -2.35302 7.24771 -7.56512 +1093 4 47.7373 2.26457 30.8018 19.6426 -7.09987 -8.69392 +1094 4 51.6402 0.582035 30.3922 15.3203 -1.97636 0.19948 +1095 4 48.6832 3.25559 28.7541 24.649 -5.28154 -1.94766 +1096 4 51.2124 2.39582 28.5799 18.4236 6.97779 -14.3308 +1097 1 48.3633 0.438016 35.503 -1.69139 30.1001 11.6909 +1098 2 47.6687 41.7006 36.6492 0.613805 18.6924 -40.9612 +1099 2 46.264 41.3694 36.1307 -7.02361 -30.4834 5.87484 +1100 3 45.3463 0.246853 35.8895 18.8914 5.06283 8.3795 +1101 4 48.1281 1.45816 35.4039 5.5506 -16.4063 -0.101422 +1102 4 48.2062 40.7837 36.9784 6.36967 -2.21031 -8.42979 +1103 2 47.5958 0.687745 37.8565 -25.4558 59.2473 29.5222 +1104 2 46.6931 0.064749 39.0402 -2.78345 4.00632 18.8053 +1105 2 47.0383 40.4557 39.4221 -33.2538 18.6268 -20.4936 +1106 2 46.93 0.927044 40.3419 31.4794 -11.2994 1.29194 +1107 4 47.1354 1.76149 37.5629 9.48386 -42.5729 7.15928 +1108 4 48.6298 0.997945 38.2155 -14.6806 -19.3715 -2.98409 +1109 4 45.5391 0.148422 38.8474 30.3772 -4.98305 -7.99897 +1110 4 47.9695 40.2725 39.9165 32.6255 3.33763 11.188 +1111 4 46.9967 39.7545 38.5575 0.158611 5.44488 0.559019 +1112 4 46.2719 40.0836 40.1333 -2.82757 0.291607 -0.331179 +1113 4 48.0832 1.04093 40.5802 -35.3824 -1.71169 -8.39188 +1114 4 46.4823 0.388091 41.2333 0.118939 13.4124 -7.57083 +1115 4 46.4764 1.95182 40.2253 3.79994 -8.06745 5.67231 +1116 1 46.1155 40.0363 35.9994 32.2071 3.49142 -20.6914 +1117 2 44.9353 39.2817 35.7114 0.014229 -40.6503 61.2515 +1118 2 44.4179 38.8949 37.157 4.06758 -27.6469 18.473 +1119 3 45.1574 38.4668 38.0935 -15.0116 19.769 -34.2637 +1120 4 46.9934 39.487 36.0733 -14.8983 -9.5139 0.794979 +1121 4 44.1193 39.9156 35.4266 -15.9448 22.0113 -37.9939 +1122 2 45.2307 37.9502 34.8403 3.73878 29.7444 42.1248 +1123 2 44.043 37.0324 34.841 -52.9272 -13.7306 14.9234 +1124 2 45.6185 38.368 33.4399 7.42128 1.51593 -38.9882 +1125 4 46.0406 37.394 35.3664 8.69137 1.61483 -3.86581 +1126 4 43.4486 36.945 35.811 20.0159 3.18287 -12.2628 +1127 4 44.3645 35.9957 34.6605 0.118723 -8.68919 -11.9568 +1128 4 43.2413 37.3473 34.1301 7.80666 -3.9283 -7.25571 +1129 4 46.619 38.86 33.4411 -0.357581 -2.40345 0.816384 +1130 4 44.931 39.1517 33.0584 -3.3954 -0.0150932 -1.42103 +1131 4 45.65 37.5606 32.6192 -0.759822 9.78394 24.304 +1132 1 43.0637 38.9039 37.3301 16.2039 -1.11298 52.5829 +1133 2 42.3901 38.4825 38.6382 8.13363 32.9232 -36.228 +1134 2 41.8706 37.0909 38.467 10.8397 -12.8704 71.8875 +1135 3 41.4837 36.7016 37.4073 -23.2793 -18.8499 -56.9312 +1136 4 42.5052 38.9697 36.5072 -31.8536 4.61581 -21.2592 +1137 4 43.1805 38.4127 39.3754 18.2924 -0.774441 22.1039 +1138 2 41.3003 39.5089 39.1545 11.9555 -3.56475 0.849013 +1139 2 41.9844 40.8891 39.6202 11.8289 -38.672 35.4909 +1140 2 41.1032 0.170603 39.4187 0.299182 35.0028 -21.1028 +1141 2 42.4599 40.8175 41.1074 30.4283 -6.43954 -3.58257 +1142 4 40.7378 39.0113 40.0259 3.55617 13.764 -16.8053 +1143 4 40.5882 39.6834 38.2893 4.7664 -2.44084 15.6093 +1144 4 42.9174 41.0251 39.0897 16.4872 7.11459 -27.4623 +1145 4 41.5448 1.21778 39.6878 -5.64292 -30.3916 -9.38981 +1146 4 40.1969 0.063548 40.0003 -21.2204 -0.202137 11.1399 +1147 4 40.8028 0.152067 38.3319 -0.566182 12.1591 9.51378 +1148 4 41.6814 40.5448 41.8308 -8.42244 -8.91154 4.32363 +1149 4 42.887 41.7652 41.4977 -6.37808 7.37928 -6.87517 +1150 4 43.378 40.1338 41.1957 -24.337 0.845851 0.000130478 +1151 1 41.833 36.287 39.5864 -11.7269 -9.12911 -32.1296 +1152 2 41.2021 34.942 39.6247 -13.3362 -7.3841 -33.9439 +1153 2 39.8438 35.1095 40.3167 -2.23182 -18.8086 0.488263 +1154 3 39.8319 35.4679 41.5133 -14.6884 5.15074 -23.9167 +1155 4 42.1857 36.6275 40.4819 6.41783 1.01312 8.70708 +1156 4 41.0734 34.4248 38.4971 0.391294 34.8961 43.783 +1157 2 42.0436 33.9307 40.4129 10.4134 -33.9193 29.8386 +1158 2 41.3224 32.6645 41.0046 18.9395 -8.84266 -15.0635 +1159 2 42.1741 31.41 41.1086 26.4224 -37.0889 -5.20117 +1160 1 43.3231 31.527 0.12404 8.16009 54.2467 4.49909 +1161 2 44.392 30.7336 0.312631 -11.8213 -13.5239 -25.8004 +1162 1 44.683 29.6211 41.5456 -0.875823 -13.5136 -9.93246 +1163 1 45.3567 31.1357 1.10637 -40.5913 52.4111 16.4216 +1164 4 42.6035 34.3028 41.3288 -3.49471 12.9719 -23.3931 +1165 4 42.7742 33.539 39.6653 10.0701 4.50298 5.32726 +1166 4 40.5106 32.3417 40.3808 -25.7726 1.2565 -24.6898 +1167 4 40.8602 32.7415 0.05618 -15.4481 23.3498 31.3369 +1168 4 42.5775 31.2408 40.0556 -4.97325 -9.97334 14.9806 +1169 4 41.5239 30.4863 41.4302 18.1675 25.5375 -11.7586 +1170 4 43.4773 32.5278 0.495625 -12.2609 -36.3484 -6.98406 +1171 4 44.1847 29.2591 40.6938 -0.904676 10.2844 18.7349 +1172 4 45.5197 29.0942 41.8602 -5.70345 -5.08504 -8.10101 +1173 4 45.1981 31.9946 1.67722 9.89922 -9.52065 -4.53153 +1174 4 46.1063 30.5613 1.39407 36.7186 -26.409 10.0907 +1175 1 38.7328 34.6894 39.6013 4.46457 11.7984 -0.102478 +1176 2 37.3765 34.7683 40.1611 -21.3466 -3.56213 -4.53749 +1177 2 37.2086 33.6902 41.246 35.3807 -34.3386 -58.3615 +1178 3 37.7056 32.5617 40.9531 -12.3371 14.3328 36.9617 +1179 4 38.7903 34.2139 38.6548 1.70782 19.6852 25.699 +1180 4 37.2103 35.7436 40.6571 5.74575 10.1154 -0.0963519 +1181 2 36.2415 34.546 39.0669 -3.18027 -0.0437456 15.212 +1182 2 36.1408 35.6492 37.9204 39.4301 -27.8538 10.4422 +1183 2 35.3755 35.0392 36.7616 2.61616 7.91146 -44.6699 +1184 2 35.4893 36.9279 38.4153 -43.6456 26.6605 -35.0263 +1185 4 35.2587 34.5127 39.627 5.22859 0.340849 -7.95454 +1186 4 36.3572 33.4874 38.6664 0.260323 14.7009 0.217726 +1187 4 37.2087 35.8382 37.5664 -16.1128 3.65721 5.42823 +1188 4 35.4477 35.6456 35.7653 9.36321 -17.9472 26.5571 +1189 4 34.3056 35.0154 36.9225 -21.8403 -4.8414 12.2215 +1190 4 35.6878 33.9672 36.6241 -0.675121 9.51327 -11.2908 +1191 4 35.3533 37.7352 37.5449 14.646 -26.9923 30.0517 +1192 4 36.0883 37.365 39.2255 0.238586 8.99863 9.94523 +1193 4 34.398 36.7236 38.7331 27.4296 3.60145 2.66053 +1194 1 36.5178 33.9861 0.43319 -0.886806 18.5628 10.9627 +1195 2 36.4316 33.2481 1.68402 -23.714 -26.6299 -2.13495 +1196 2 35.1244 33.7124 2.42366 15.5385 -30.3313 2.36588 +1197 3 34.7644 34.9026 2.51705 2.20922 -14.5348 -10.7235 +1198 4 35.9714 34.8641 0.38304 3.21168 -9.87759 6.15105 +1199 4 36.3983 32.0948 1.44989 -1.82422 33.6343 5.26777 +1200 2 37.6595 33.5578 2.59019 11.8109 -15.526 -8.95992 +1201 2 37.7925 32.6548 3.8947 -1.46637 37.0951 -40.7395 +1202 2 39.0729 32.9162 4.76145 9.33062 17.9701 -6.69315 +1203 1 39.1272 34.3057 5.34055 -12.0513 -47.2871 -14.6565 +1204 2 40.0361 34.6964 6.22226 19.4309 2.99614 33.8109 +1205 1 41.0505 33.9844 6.76852 5.72064 -28.58 -41.8643 +1206 1 39.7581 35.8909 6.75898 -16.291 -41.0737 -43.8581 +1207 4 37.6558 34.6526 2.69615 5.74115 8.80853 20.4616 +1208 4 38.5677 33.342 1.97837 2.62182 1.38243 0.976295 +1209 4 37.7082 31.6119 3.52088 7.51898 -7.43262 10.1799 +1210 4 36.8684 32.8569 4.46033 -3.22235 -4.22142 15.6354 +1211 4 40.0987 32.7161 4.26669 -27.6432 -2.90908 0.926336 +1212 4 38.962 32.1623 5.56307 10.4764 0.325422 12.3641 +1213 4 38.2956 34.9173 5.26655 4.54825 -8.39051 -8.34855 +1214 4 41.5169 33.1039 6.38476 -28.6266 25.8655 1.14646 +1215 4 41.608 34.3491 7.51377 7.8916 19.9746 23.1278 +1216 4 38.9281 36.336 6.40181 -18.5651 19.0558 1.42199 +1217 4 40.2702 36.4189 7.40653 35.8571 19.9594 40.0309 +1218 1 34.4344 32.6714 2.9841 11.9274 27.4669 5.1488 +1219 2 33.2874 32.9292 3.81699 -8.08564 -7.68863 -5.88537 +1220 2 32.3224 31.7651 3.90854 -17.2979 -17.3182 38.1098 +1221 3 31.6331 31.611 4.98833 24.1293 6.49939 -41.9496 +1222 4 34.8176 31.7057 3.00707 -6.83555 3.8884 -0.368261 +1223 4 33.5991 33.291 4.83995 -4.39941 -8.915 -13.4113 +1224 4 32.6658 33.7351 3.38441 -0.220857 8.92322 -1.65762 +1225 1 32.2676 30.8833 2.86064 7.18924 -6.28537 -11.1453 +1226 2 31.5304 29.6622 2.84554 -44.3988 -8.55194 41.4736 +1227 2 32.0114 28.4719 1.98523 24.1065 42.5964 20.3644 +1228 3 31.2338 27.9142 1.1781 -2.45095 -15.5808 -11.9787 +1229 4 32.835 30.9065 1.99868 7.60542 11.1676 6.22148 +1230 4 31.4977 29.325 3.94534 -1.848 -5.68036 -21.1002 +1231 4 30.428 29.9278 2.63242 23.021 -11.1829 0.219584 +1232 3 33.2484 28.1785 2.03016 -12.1294 -5.65166 -6.61988 +1233 6 29.6841 33.0367 2.60309 -21.6771 -19.3453 -3.47113 +1234 4 28.7948 33.122 2.96731 -0.0142705 6.34055 1.55972 +1235 4 29.6278 32.12 2.27587 17.6678 13.2788 -5.74715 +1236 6 1.91248 24.7582 28.0699 4.20875 0.224039 17.8866 +1237 4 1.01839 24.445 28.2798 3.51323 0.855994 -2.65004 +1238 4 2.43926 24.5752 28.8738 -5.90795 -3.90565 -13.7536 +1239 6 8.97597 35.4266 7.06834 5.04 -9.06312 -1.25332 +1240 4 8.25108 36.0541 6.94232 -0.597114 -1.88223 0.564045 +1241 4 9.78632 35.9205 6.90416 2.6498 8.25727 -2.9232 +1242 6 37.9306 35.2271 23.5275 -29.4197 8.6633 8.88923 +1243 4 37.6331 35.3765 22.6307 -13.538 -1.59668 -6.74716 +1244 4 38.842 35.1051 23.4294 41.2281 -9.97035 -1.96517 +1245 6 11.37 34.6061 20.3231 29.8185 18.8627 -18.7977 +1246 4 10.4583 34.7066 20.5358 -23.2141 -5.0309 12.4901 +1247 4 11.7775 33.9686 20.9051 -0.738527 -14.291 8.66526 +1248 6 3.04799 13.1152 13.5136 35.0099 19.4917 13.0876 +1249 4 2.1896 12.8159 13.7818 -12.1985 -3.35561 6.33527 +1250 4 3.35102 13.7724 14.1976 -9.84998 -14.2313 -17.3692 +1251 6 9.17749 22.3786 24.885 -4.81993 3.49977 17.5169 +1252 4 8.99718 21.9861 24.0258 2.67933 0.293026 -6.97176 +1253 4 8.3097 22.5185 25.3032 2.93356 -2.2731 -6.67367 +1254 6 31.1417 36.1188 7.44168 3.96214 -4.62609 4.57576 +1255 4 30.9859 35.1633 7.26174 3.91063 19.8072 -8.10584 +1256 4 31.8759 36.4086 6.86762 -9.43736 -11.0335 0.220205 +1257 6 20.3122 0.171955 30.1364 24.228 8.43021 7.74329 +1258 4 20.1467 1.09565 29.8896 -9.06662 -5.17995 0.122132 +1259 4 21.2388 0.205679 30.4532 -11.6638 -2.99571 -4.85501 +1260 6 32.6752 3.01477 5.14905 7.73556 0.409651 25.0992 +1261 4 32.0607 2.27652 4.98052 6.16059 10.1356 9.58904 +1262 4 32.7887 3.0902 6.13894 -10.3787 -11.0045 -24.4474 +1263 6 26.2394 8.28697 11.5977 20.1187 4.68976 23.8355 +1264 4 26.2546 7.39802 11.997 -1.81228 7.23555 -2.12718 +1265 4 26.8422 8.82061 12.1901 -18.4274 -19.7459 -23.7973 +1266 6 1.08156 20.2558 0.892389 0.445896 -40.4816 -11.3523 +1267 4 0.921065 19.2784 0.845371 -9.22979 28.4068 22.5673 +1268 4 1.8129 20.2775 0.290341 19.5395 18.0975 -11.5753 +1269 6 29.152 22.9159 1.42964 -10.353 11.3862 1.77115 +1270 4 28.6638 23.7219 1.70393 12.045 -15.0113 -5.27942 +1271 4 29.6471 22.6066 2.20087 0.367353 7.17244 2.17898 +1272 6 34.1439 34.8173 6.47837 -14.6134 34.7664 -13.6599 +1273 4 34.8234 34.3556 6.01831 17.3611 -13.8412 -2.82442 +1274 4 33.8746 34.3136 7.2252 -0.385324 -14.0922 18.4225 +1275 6 25.1602 37.1811 26.5285 37.3138 -10.4299 -24.6025 +1276 4 24.6611 37.8475 26.9305 -29.1138 25.753 30.5337 +1277 4 25.9902 37.6718 26.3423 -2.02618 -10.7722 -5.27175 +1278 6 14.5359 22.233 15.6757 -38.1082 -52.4317 -17.2355 +1279 4 14.0373 21.3219 15.6008 31.4468 51.1923 15.0921 +1280 4 14.2115 22.7284 14.9124 6.42666 2.88962 4.6194 +1281 6 2.85765 5.85542 4.07926 -11.0889 31.9932 11.5474 +1282 4 3.43051 5.71014 4.8302 4.50985 -17.8875 11.7313 +1283 4 2.47546 6.74142 4.27679 -1.8522 -19.462 -7.62003 +1284 6 27.6173 26.7153 22.7048 3.02536 -24.7668 37.2 +1285 4 26.7794 26.2561 22.7471 -5.49099 -10.4557 3.23975 +1286 4 27.5338 27.2427 21.9498 -2.81898 29.5538 -40.3285 +1287 6 17.7815 0.60275 22.3967 -9.44347 22.192 16.8557 +1288 4 17.1106 0.664367 23.1174 8.05472 -4.70436 -13.4643 +1289 4 18.0991 1.53066 22.3547 -2.50437 -12.3009 -7.04453 +1290 6 8.08803 9.43976 10.5674 4.80966 -47.9744 28.0614 +1291 4 8.01535 10.2871 10.1695 -8.25869 32.7817 1.56345 +1292 4 8.12483 9.46261 11.5696 0.628604 12.1613 -30.4224 +1293 6 15.3459 8.71493 30.7579 -11.6347 7.91644 6.32427 +1294 4 15.6589 9.0755 29.9373 15.0271 -3.29406 -15.5675 +1295 4 14.5238 9.21191 30.8811 4.80809 -7.40019 11.405 +1296 6 11.0133 17.2839 37.5617 38.0352 -12.2544 -11.7999 +1297 4 10.7898 18.2056 37.405 -17.5453 -0.0751596 7.29682 +1298 4 10.2607 16.7791 37.8546 -17.0302 3.42722 4.74802 +1299 6 42.1004 25.1498 20.3879 -5.861 18.5914 -24.6259 +1300 4 41.6093 25.7579 19.7998 14.6917 -4.46771 2.10695 +1301 4 41.6207 25.2703 21.1911 -4.19275 -5.86855 25.2901 +1302 6 25.8665 4.70671 33.8486 1.7241 -2.25531 12.4518 +1303 4 25.7694 4.46132 32.9448 -0.891619 -14.6084 -22.569 +1304 4 25.7648 5.65611 33.7952 0.475958 14.7418 11.4125 +1305 6 28.7412 10.81 24.3536 52.8166 -39.1996 0.778281 +1306 4 29.1275 10.6396 25.241 -21.7381 14.0631 -10.6288 +1307 4 29.4032 10.2753 23.8346 -27.1554 16.6107 -4.2243 +1308 6 5.01189 41.8147 11.1021 -10.1881 -24.042 21.7575 +1309 4 5.95007 41.5814 10.9281 -9.39093 5.64723 11.7156 +1310 4 4.65803 41.218 11.8386 16.8172 15.7397 -32.6044 +1311 6 51.752 12.7769 30.1551 43.115 4.76279 10.9474 +1312 4 51.4305 13.1775 29.3474 0.253404 7.28674 -13.194 +1313 4 52.748 12.9494 30.1798 -32.3905 -5.4963 0.108494 +1314 6 7.60816 6.20909 6.53323 -10.2625 -22.9413 3.332 +1315 4 6.75131 6.36879 6.93991 1.04412 16.1391 1.16177 +1316 4 7.47061 5.28848 6.27373 8.51121 0.713964 -9.51027 +1317 6 14.6661 26.987 30.1548 0.873164 4.36141 0.355215 +1318 4 14.582 27.1099 31.1251 1.36022 -4.92112 -14.8153 +1319 4 15.2266 27.7026 29.8055 -8.21389 -0.931444 11.6021 +1320 6 15.3264 3.73283 21.1643 -10.33 -3.58504 -6.01241 +1321 4 14.8638 4.27764 21.8464 -0.83547 -19.2341 -16.6374 +1322 4 14.7237 3.15769 20.6119 12.9204 22.2517 21.9232 +1323 6 18.6273 30.44 6.46759 12.0392 -23.7352 17.6185 +1324 4 19.0475 29.6706 6.98693 -16.3462 35.3997 -15.3304 +1325 4 19.3457 31.0864 6.33287 -5.93154 -6.64461 4.30044 +1326 6 40.7697 1.30953 12.81 -7.42069 2.69181 -0.220133 +1327 4 39.8771 1.67487 12.9664 8.30469 -1.85755 -8.75546 +1328 4 41.0842 1.69163 11.9727 1.23155 -3.30642 0.910493 +1329 6 17.7383 20.7435 41.5913 -9.25323 7.68498 -13.188 +1330 4 16.7989 21.0745 41.5362 27.0903 -5.35562 -1.00027 +1331 4 18.2994 21.1605 40.9095 -9.45455 4.50919 10.4973 +1332 6 20.4558 2.13279 12.3403 -30.0447 18.1891 -47.0851 +1333 4 19.8108 1.39557 12.2573 15.3988 9.29294 19.6505 +1334 4 20.198 2.64755 11.5038 12.9177 -17.2886 33.121 +1335 6 9.85302 37.1833 18.074 6.71136 -14.9304 -23.7857 +1336 4 9.92221 37.5908 18.9423 10.0316 4.42551 4.50256 +1337 4 10.7455 37.1149 17.635 -18.8442 6.56171 18.5414 +1338 6 22.8282 7.40677 18.9114 -6.23678 0.804763 -35.7596 +1339 4 23.277 7.74075 18.0859 -11.7777 -2.90663 21.4919 +1340 4 21.8757 7.287 18.6972 16.9035 1.85128 0.334711 +1341 6 12.8573 6.85868 39.0594 6.78943 -21.4649 -19.4044 +1342 4 12.3495 7.63841 39.2092 -16.9303 20.8315 3.03628 +1343 4 13.4346 6.77393 39.8096 4.28484 1.06254 16.6435 +1344 6 10.1565 2.40612 23.2517 -6.6479 23.561 31.1588 +1345 4 10.4099 1.98923 22.4441 -4.01424 -6.38426 -29.0568 +1346 4 9.49005 3.10319 23.0571 9.63138 -11.2124 -3.87372 +1347 6 12.5542 20.2161 19.5705 -7.34833 3.07917 -34.9419 +1348 4 11.7057 19.8107 19.7825 -3.93433 -3.45282 3.31954 +1349 4 12.4683 20.3478 18.5882 13.2674 0.522362 30.6915 +1350 6 53.8557 6.35775 18.9347 50.5758 7.3162 -16.743 +1351 4 53.0168 6.07594 19.2456 -23.2698 -10.9568 16.0684 +1352 4 54.5479 6.04339 19.5529 -19.4302 5.44353 -5.27334 +1353 6 1.75058 4.00903 13.2441 23.5728 -28.6973 -20.2265 +1354 4 1.21884 4.54583 13.7916 -24.4496 15.7193 15.6535 +1355 4 1.39876 3.10072 13.3493 7.47096 11.1043 -1.96467 +1356 6 2.68902 16.4655 4.58797 17.5454 -16.7281 26.1549 +1357 4 3.46748 16.2798 5.17846 -23.6637 11.3752 -17.7986 +1358 4 3.0109 17.1109 3.97132 2.36318 9.59715 -15.9168 +1359 6 22.6274 7.40182 35.0529 -33.099 -8.93325 -69.8706 +1360 4 21.8922 7.07895 34.3703 46.348 20.1786 48.898 +1361 4 22.5995 6.76718 35.7474 -8.35572 -20.8537 22.0506 +1362 6 30.6396 27.885 19.9 19.0923 35.3411 -25.0547 +1363 4 31.1106 28.5954 19.3754 -18.5592 -24.8751 19.2783 +1364 4 29.9814 27.5098 19.295 5.17179 -8.35919 5.46264 +1365 6 18.3573 9.54392 6.2041 9.96047 7.12844 39.1223 +1366 4 18.327 9.09374 5.37857 3.10343 -12.6247 -24.8999 +1367 4 19.1177 9.18386 6.70986 -9.9052 0.872737 -11.1311 +1368 6 21.018 30.3894 30.8381 -12.2875 -2.46479 40.1773 +1369 4 21.7266 31.0151 30.932 9.98027 8.24448 -8.07198 +1370 4 20.7269 30.28 31.7939 -0.642204 -5.24287 -40.3987 +1371 6 28.323 4.36597 15.0837 1.12527 39.8195 10.6489 +1372 4 27.8986 3.55092 15.2676 -12.4099 -32.2848 2.02696 +1373 4 29.0009 4.19376 14.4446 14.1396 -7.65384 -8.86362 +1374 6 12.7814 0.64254 16.5262 -20.2521 41.8336 -1.49998 +1375 4 13.0387 1.47629 17.0069 -1.64601 -27.4009 -13.133 +1376 4 12.0897 0.933072 15.8712 20.715 -4.46996 16.4219 +1377 6 27.5603 35.1844 8.24072 -26.8161 -1.20469 12.7263 +1378 4 28.0791 35.3455 7.47089 6.94403 2.76433 -19.537 +1379 4 26.8275 34.582 7.96906 18.9853 12.4469 9.56437 +1380 6 24.0704 5.17451 40.9985 43.9791 -14.9803 45.716 +1381 4 24.6298 5.96615 41.2045 -19.6374 -8.83437 -20.0494 +1382 4 23.3625 5.28724 40.4007 -22.1054 20.8081 -27.5224 +1383 6 16.8467 24.9145 28.3061 -32.8066 71.0274 -23.4158 +1384 4 15.8676 25.1613 28.454 39.6061 -31.4713 1.92714 +1385 4 17.0718 25.6559 27.6632 3.37355 -28.1253 20.4487 +1386 6 20.8411 12.7971 17.0095 43.3655 -24.1139 -5.17775 +1387 4 20.9692 13.6698 17.4217 0.0861137 -1.96629 -7.53612 +1388 4 21.7712 12.4167 16.7645 -47.1299 18.5523 16.3808 +1389 6 35.7683 23.0344 30.9263 1.08866 -13.108 5.55839 +1390 4 34.803 23.1301 30.928 3.64223 -3.31893 2.04139 +1391 4 35.9803 22.5404 31.7512 0.26244 15.2618 -11.5602 +1392 6 36.3065 21.404 25.8788 21.1988 16.3215 -11.4752 +1393 4 35.3711 21.2912 25.8279 -29.04 -8.19979 -7.71966 +1394 4 36.6742 20.6179 26.2596 7.44281 -15.7003 9.85929 +1395 6 13.4865 6.74911 5.29345 -32.6693 78.3701 45.7352 +1396 4 13.9616 6.05619 4.98306 41.5093 -80.328 -47.9816 +1397 4 12.7805 7.00791 4.71674 -14.9335 -5.37764 -13.3979 +1398 6 20.8104 20.4092 13.7653 1.99296 11.0688 -14.7475 +1399 4 21.268 20.4545 14.5989 11.9976 -3.76106 7.6647 +1400 4 19.8959 20.3184 13.9984 -15.4264 -4.27358 -1.02469 +1401 6 20.3637 29.125 1.38742 -7.39452 3.20569 15.6829 +1402 4 20.6257 29.8678 1.97015 -13.6171 -7.9879 -3.97808 +1403 4 19.4728 28.7955 1.69287 22.5847 10.4694 -9.78123 +1404 6 50.8792 13.1212 37.2655 -4.22961 23.9091 37.9372 +1405 4 51.3893 12.5589 37.8771 -2.47029 4.54984 -9.0483 +1406 4 50.5869 13.8674 37.8656 5.03029 -21.5284 -25.2034 +1407 6 33.9282 34.1694 20.494 -12.758 16.9363 4.62304 +1408 4 33.9505 34.3661 19.5368 -1.52487 0.481952 13.5649 +1409 4 33.2327 34.7631 20.901 14.0918 -19.53 -17.3949 +1410 6 26.2111 28.0581 27.5584 -15.6012 -12.4051 -9.62147 +1411 4 26.6887 28.3319 28.3498 -5.67664 4.83839 -0.885474 +1412 4 25.2376 28.0657 27.7416 20.5709 -1.16679 -1.23567 +1413 6 7.682 21.3042 4.28531 -31.6563 9.11884 52.3302 +1414 4 8.36407 20.9023 3.81015 41.1991 -18.6864 -33.8238 +1415 4 7.19271 21.9105 3.74865 -6.01459 10.7978 -19.2095 +1416 6 22.0049 15.1615 5.91526 -5.59087 32.8095 7.59658 +1417 4 22.5291 15.4011 5.14076 -1.79158 -8.25489 -6.60562 +1418 4 21.8369 14.2416 6.04435 2.97447 -25.4321 -3.26552 +1419 6 21.7136 24.0096 3.8157 22.5859 -13.9702 -11.1371 +1420 4 22.6792 24.1846 3.95073 -20.2229 4.30251 2.28349 +1421 4 21.6957 23.2604 3.18041 -1.04284 4.75891 13.5064 +1422 6 11.5672 23.7812 12.5534 10.6653 17.5289 -0.525849 +1423 4 11.8567 24.7317 12.4283 -11.704 -31.033 2.93832 +1424 4 11.2483 23.6794 13.4494 -5.02459 5.94744 7.15157 +1425 6 32.3679 18.058 29.8144 -2.59991 12.5874 27.6023 +1426 4 33.2958 17.8537 29.9681 1.40206 -2.08885 -2.88861 +1427 4 32.1708 17.8352 28.9168 3.64727 -16.5589 -23.8097 +1428 6 9.27501 12.3901 30.3257 8.89695 -9.73537 -4.18026 +1429 4 8.97738 13.0169 30.9954 -4.04452 2.00113 -0.0309771 +1430 4 10.1278 12.0418 30.6776 -19.7256 9.24572 -11.0885 +1431 6 40.1671 25.9203 9.1352 -31.1658 -6.55029 4.71016 +1432 4 40.7952 25.2818 9.45931 8.36253 -10.0667 -0.250848 +1433 4 40.6474 26.7215 9.01492 17.3912 21.2934 -6.4579 +1434 6 43.1616 32.3487 37.3267 7.45809 -19.2286 11.3512 +1435 4 42.8399 32.8446 36.5586 -11.2032 -5.45956 10.184 +1436 4 42.4733 31.7245 37.6799 8.3011 17.0164 -20.2151 +1437 6 44.0911 6.28198 31.259 8.64406 -6.47735 -33.2401 +1438 4 43.4563 6.84482 31.6606 -21.1773 24.4303 10.8162 +1439 4 44.5952 5.92873 31.9644 15.9286 -14.2375 24.3689 +1440 6 10.2063 18.8787 19.6978 14.6089 -0.63771 -2.74842 +1441 4 10.128 18.3979 20.5267 6.04825 -4.13467 -1.20166 +1442 4 9.36891 19.3219 19.635 -15.0357 8.38504 -1.1225 +1443 6 7.0561 15.5922 15.0299 -16.4573 19.9198 -23.3889 +1444 4 7.18612 15.4783 14.0721 1.05096 2.95086 4.94392 +1445 4 7.41457 14.833 15.4354 13.8635 -34.6267 13.25 +1446 6 24.544 3.4899 27.8655 -14.5565 -8.97091 -7.81951 +1447 4 23.6823 3.28725 28.2588 1.61952 11.0081 14.175 +1448 4 24.3729 3.16547 26.9791 10.0044 -2.74415 -7.35546 +1449 6 54.4109 31.8087 9.71194 -6.99911 23.6955 33.3298 +1450 4 53.8413 31.5567 9.00593 -8.22136 -4.9258 -26.1741 +1451 4 54.0752 32.6964 9.97695 10.2913 -15.383 -7.59421 +1452 6 6.81072 17.0817 36.2069 -39.6649 -0.569341 -18.8672 +1453 4 5.9036 16.7161 36.0961 17.2423 3.35707 18.397 +1454 4 7.03883 17.1994 35.2786 19.8939 2.17194 6.76773 +1455 6 28.6373 7.46216 20.4204 -3.00228 3.72915 -26.9716 +1456 4 27.791 7.71165 20.8314 -1.23568 -3.59083 -7.19581 +1457 4 28.5788 7.67124 19.4449 -3.89686 1.20908 30.1283 +1458 6 17.0427 1.7136 8.36469 -7.39711 4.96373 -17.441 +1459 4 16.9511 0.79552 8.17539 8.34993 -30.6792 14.2707 +1460 4 16.7364 2.03503 7.50962 2.58977 23.9868 7.32556 +1461 6 19.1319 19.334 35.5748 25.2315 11.3156 3.71898 +1462 4 18.4163 18.7293 35.4559 -12.7574 -15.0058 -3.77114 +1463 4 19.9108 18.8059 35.8312 -7.49406 2.79856 2.97864 +1464 6 7.31044 31.3665 13.5876 -12.5896 -10.3186 -18.1643 +1465 4 6.86348 30.5057 13.838 5.41483 30.5465 -8.86898 +1466 4 6.71656 31.9291 13.023 7.05746 -22.9991 7.02109 +1467 6 16.6555 5.24573 12.8486 0.44122 -36.1931 20.2204 +1468 4 17.4189 5.79101 12.9112 23.6003 17.0932 2.01526 +1469 4 16.8511 4.45507 13.4194 -12.0332 11.5633 -21.5138 +1470 6 43.8917 12.7482 34.58 -33.2024 -13.6106 -1.45858 +1471 4 43.9807 13.5999 34.156 2.60816 15.5254 -0.13451 +1472 4 42.9242 12.5381 34.5161 22.3754 -3.96122 -2.5942 +1473 6 42.656 36.4522 28.5282 -7.17959 22.9727 1.13167 +1474 4 42.279 37.3416 28.6522 -7.55712 -15.8866 -0.526154 +1475 4 43.5285 36.675 28.2003 16.3904 -10.8581 0.329061 +1476 6 35.3704 15.0467 6.02622 35.7531 43.3754 17.6476 +1477 4 35.9258 15.8884 5.86958 -26.5611 -35.5954 0.991204 +1478 4 34.7923 14.9488 5.27074 -5.69332 -0.0870189 -10.0798 +1479 6 19.4034 5.85396 6.19026 -42.6676 -37.2433 -25.4755 +1480 4 18.4973 6.11578 6.46985 14.7962 -6.51198 7.73248 +1481 4 20.0178 6.47164 6.48735 29.6225 43.4574 23.1864 +1482 6 29.2636 38.16 6.98139 -51.0091 34.2659 0.167673 +1483 4 28.4794 38.0546 7.56687 16.6219 5.90534 -14.0005 +1484 4 29.8812 37.5458 7.29338 34.0617 -33.3732 10.6718 +1485 6 19.3639 26.1879 8.4772 -1.75021 -19.5484 18.4946 +1486 4 19.3765 25.7536 9.37133 0.505418 11.6152 -20.7618 +1487 4 20.132 25.8039 8.02679 -2.64689 1.58972 6.88257 +1488 6 4.91801 16.6546 6.12902 16.8332 -1.31437 8.04366 +1489 4 5.58152 17.3 5.84506 -6.45866 4.1219 -0.991793 +1490 4 5.39084 15.8022 6.09449 -7.75564 17.9483 -2.53018 +1491 6 6.07873 16.6931 28.0679 20.4204 4.35008 -35.2212 +1492 4 5.19925 16.4426 27.8453 -29.7482 -9.15572 9.47762 +1493 4 6.44387 16.7631 27.1426 -3.77999 2.92972 38.3228 +1494 6 21.7313 29.3584 22.0941 -19.989 26.599 40.0594 +1495 4 21.5191 30.3374 22.0902 3.30888 -28.6715 -0.0155919 +1496 4 21.2646 29.0087 22.9228 20.4195 8.84702 -28.341 +1497 6 24.487 0.545827 12.8459 24.5625 -19.0276 8.44191 +1498 4 24.0381 0.883409 12.0817 -9.22903 10.6064 -10.7293 +1499 4 24.0836 0.980384 13.5911 -6.14963 8.46579 8.44801 +1500 6 18.4109 28.2545 40.3162 -15.9129 36.5713 -32.2972 +1501 4 18.3366 27.7076 41.0573 0.952339 -31.6797 34.0712 +1502 4 19.1875 27.9677 39.8503 10.0284 -2.61836 -5.50219 +1503 6 10.3807 17.4604 21.8947 -1.20821 -16.3296 3.13877 +1504 4 9.80057 16.6779 21.8113 10.8468 3.86983 1.60142 +1505 4 10.0443 17.9356 22.6521 -9.33664 9.03137 6.2204 +1506 6 13.5404 13.3591 39.6327 12.5768 11.767 30.0264 +1507 4 13.9188 14.1992 39.2886 -9.97897 -11.5724 13.3172 +1508 4 13.5464 13.3749 40.6413 1.33606 5.90172 -38.0522 +1509 6 19.5508 26.0247 24.7387 -47.8665 -1.21537 -13.2845 +1510 4 19.6189 25.3328 24.097 -5.62542 -9.91951 -19.3965 +1511 4 20.3649 25.9852 25.1641 45.3739 3.88293 31.7071 +1512 6 8.93445 25.8823 20.0822 -10.4543 -29.9419 8.18251 +1513 4 8.35083 26.4773 20.5043 -33.2288 11.519 27.1484 +1514 4 9.504 26.5029 19.6962 43.6798 16.1155 -28.0388 +1515 6 13.4493 41.2138 30.5102 -4.84662 -36.1256 25.75 +1516 4 14.2597 41.094 31.0483 -5.58856 8.18726 -8.9115 +1517 4 12.8416 40.5025 30.8796 12.8197 27.661 -18.9522 +1518 6 21.1596 21.6794 11.1163 10.7366 20.8259 2.41134 +1519 4 20.9554 20.8709 10.6777 -10.2383 -24.5438 -10.817 +1520 4 21.2276 21.4421 12.046 -2.84377 -3.57945 5.82209 +1521 6 43.5643 10.3136 15.5616 17.5969 -21.741 5.94749 +1522 4 43.2379 9.48961 15.149 2.99942 14.1859 3.68588 +1523 4 42.9802 11.0242 15.3396 -21.8087 10.2132 -10.2755 +1524 6 23.5302 5.07333 12.3088 -23.5628 55.8128 -25.3063 +1525 4 23.4112 4.1923 12.0373 1.19089 -49.3933 -5.08619 +1526 4 23.0178 5.53904 11.5656 24.5614 -12.3881 30.382 +1527 6 9.28539 15.401 4.24759 1.63269 -5.62651 -9.8947 +1528 4 9.02922 16.1115 4.82738 -12.4128 14.4693 4.40189 +1529 4 9.90895 14.9318 4.78697 15.8319 -9.58935 3.85081 +1530 6 26.711 10.8797 17.566 5.43365 -10.3343 -26.0937 +1531 4 26.4818 11.0142 18.4585 -6.06422 3.32013 41.5711 +1532 4 26.8019 11.7518 17.1937 0.341074 3.88847 -5.26754 +1533 6 26.0592 23.5875 33.6794 25.1455 50.9154 21.2543 +1534 4 25.4682 24.0785 33.1024 -8.24785 -6.01089 -9.80751 +1535 4 26.6604 24.3213 34.0779 -26.6739 -38.162 -12.8336 +1536 6 7.57385 10.4949 28.9097 -14.7972 2.07126 0.456687 +1537 4 6.75277 10.5859 29.4011 -5.17598 -12.8295 -3.89358 +1538 4 8.06091 11.2035 29.3139 24.0536 5.38729 3.77373 +1539 6 16.4953 16.9073 24.6459 13.4535 22.6993 31.6086 +1540 4 15.9363 17.7011 24.6942 7.46422 -1.49957 -9.096 +1541 4 16.1467 16.4045 23.9375 -12.5815 -17.1437 -28.632 +1542 6 12.5505 12.7927 0.441559 26.7797 -18.4986 61.4448 +1543 4 12.8902 12.7839 1.42408 -16.6807 15.1369 -51.7767 +1544 4 12.972 11.9767 0.117581 -17.3776 3.59908 -10.4186 +1545 6 6.80454 2.46926 9.04378 10.3033 -16.1572 19.5551 +1546 4 7.05376 2.92505 9.85651 -1.04006 9.78535 -3.84035 +1547 4 7.36555 1.67892 9.06596 -6.07141 -1.3767 -9.09165 +1548 6 28.8788 11.8454 12.005 47.3119 33.3239 7.75537 +1549 4 28.2175 12.4307 11.6211 -4.89696 7.77957 0.00959457 +1550 4 29.7805 12.2922 11.8721 -37.0304 -14.6121 1.30522 +1551 6 44.6756 32.5924 29.7091 -46.8228 -4.47104 18.0754 +1552 4 43.7214 32.9254 29.5641 42.8383 -8.78111 -1.84094 +1553 4 44.558 31.8742 30.3802 4.31467 20.1075 -17.1439 +1554 6 28.6099 15.1189 32.288 -8.09168 -64.7739 -6.10589 +1555 4 29.0591 15.887 31.9855 13.2175 18.1439 -15.8441 +1556 4 29.0109 14.3064 31.825 -10.272 37.9041 18.9788 +1557 6 1.13952 22.1955 33.6303 -59.4889 25.247 28.7943 +1558 4 0.675447 22.8098 33.0333 5.4615 -9.68619 7.91413 +1559 4 1.8611 21.9185 33.1521 52.5767 -22.4691 -40.0321 +1560 6 17.4529 16.8222 9.92046 -20.0761 -24.0842 48.1247 +1561 4 17.9341 17.1517 9.19999 21.5054 13.464 -32.8219 +1562 4 17.9802 16.1035 10.3295 -2.40424 8.44812 -14.2536 +1563 6 18.74 29.8021 14.3918 16.1488 4.65404 69.9188 +1564 4 19.5966 29.6355 14.8679 -24.5899 1.22938 -11.6521 +1565 4 18.9027 29.6655 13.4911 13.4763 -5.12933 -46.2854 +1566 6 39.4106 6.51176 13.0171 8.18439 9.54271 -9.98348 +1567 4 39.7968 7.3217 12.6105 -7.82756 -18.4389 5.68309 +1568 4 39.8965 5.76959 12.6221 -1.11983 7.69721 6.02388 +1569 6 54.1122 38.2735 14.316 -26.3921 15.7841 23.5556 +1570 4 53.5092 38.7211 14.9446 14.1224 -15.8084 0.476194 +1571 4 53.7657 38.6747 13.5269 5.67525 0.359642 -25.5906 +1572 6 7.51656 32.0218 20.9281 34.7748 10.0158 34.1931 +1573 4 7.08362 31.9253 20.1193 -22.6959 2.07513 -43.8223 +1574 4 7.03544 31.4175 21.4603 -12.2713 -14.4046 24.4342 +1575 6 26.9722 15.5137 13.836 8.2831 -9.07996 -12.1546 +1576 4 27.2905 14.6773 14.2204 -10.3825 7.39938 7.42218 +1577 4 26.0228 15.629 13.9568 -6.27371 -3.74993 11.5294 +1578 6 18.3731 16.4369 32.1258 -5.47484 6.15837 -16.1574 +1579 4 18.1737 16.7054 31.2071 -0.945967 -8.38127 9.44724 +1580 4 19.0036 17.0959 32.4159 12.6478 4.85619 3.13766 +1581 6 52.4904 31.6749 23.2282 -45.8236 3.94874 65.5164 +1582 4 52.5054 32.2301 24.055 -6.11863 -14.7847 -21.5508 +1583 4 53.2278 31.9578 22.7624 44.676 11.2926 -39.5338 +1584 6 2.17063 9.69676 28.2025 -10.599 22.0242 17.0864 +1585 4 2.41083 10.574 27.888 12.6445 -0.15763 -12.1006 +1586 4 1.36653 9.91172 28.7063 1.66945 -10.1846 4.32482 +1587 6 32.9295 0.084333 22.579 -26.8721 -17.4052 -13.8633 +1588 4 33.2309 41.109 22.2818 0.690852 17.8844 8.89147 +1589 4 33.6446 0.598803 22.932 23.7791 -0.031599 0.0852179 +1590 6 20.7171 41.5453 38.643 51.9522 19.855 -62.1487 +1591 4 20.0643 41.0408 39.0691 -29.2365 -22.9372 13.5286 +1592 4 20.9788 41.0468 37.7869 -12.0924 18.2625 49.3819 +1593 6 43.2965 24.3242 12.1559 29.4143 27.7167 -28.3716 +1594 4 43.2964 25.2918 12.2975 -10.3211 -14.9579 7.88207 +1595 4 44.0244 24.2792 11.4826 -12.2932 -11.2644 22.4039 +1596 6 22.0333 36.2992 11.8143 -17.8744 11.1706 -5.23693 +1597 4 21.6038 36.9407 11.2131 12.0614 -9.84488 11.7859 +1598 4 22.8639 36.0559 11.3996 4.49067 -2.6397 -1.6843 +1599 6 50.7446 20.5307 30.3299 -19.4296 24.1009 0.394401 +1600 4 50.3769 20.0585 31.0978 -4.60399 -0.499453 -6.82258 +1601 4 50.1204 21.2977 30.1594 19.9431 -26.9935 4.34337 +1602 6 20.8379 3.84934 18.1872 -10.63 2.24574 17.9634 +1603 4 21.6372 4.15439 17.7675 6.81748 4.13844 -2.44268 +1604 4 20.7537 4.31685 19.0447 1.53322 -4.30004 -12.0579 +1605 6 4.001 20.6421 6.99361 -18.7611 -9.71733 3.72301 +1606 4 3.09723 20.6004 6.53941 30.5715 -8.65918 22.3858 +1607 4 4.00786 20.2035 7.89591 -15.2068 14.2544 -28.772 +1608 6 11.948 15.4413 41.4409 9.86263 -45.3449 -5.39948 +1609 4 11.9713 14.4541 41.6361 -2.32711 35.624 3.02695 +1610 4 12.4708 15.4889 40.6181 -5.28805 11.0492 6.42 +1611 6 3.00764 18.5435 38.9252 6.90717 -29.584 40.0663 +1612 4 3.56523 17.7255 38.8717 -9.75827 16.9893 -1.25399 +1613 4 2.92934 18.9138 38.0721 -1.66709 15.3109 -35.9518 +1614 6 8.5978 38.8858 11.3072 48.4025 32.5603 4.46589 +1615 4 9.44036 39.0024 10.7943 -20.5341 -1.07382 9.55064 +1616 4 8.19448 38.1327 10.9484 -22.3544 -46.6733 -17.9601 +1617 6 12.9691 33.9778 38.4933 34.8069 -13.3685 -21.4899 +1618 4 12.6573 33.2385 37.9471 -9.06758 1.22663 10.2849 +1619 4 13.9307 33.983 38.2659 -20.4066 10.3952 14.8996 +1620 6 4.69069 11.9902 6.04709 5.57568 0.955193 2.63183 +1621 4 3.83092 11.6207 5.79405 1.19943 -2.71585 -3.65246 +1622 4 5.36696 11.7708 5.36999 -19.9658 -4.94035 2.87891 +1623 6 10.8381 15.9154 25.2196 -36.4648 2.02786 -4.38258 +1624 4 11.7191 16.2167 25.3262 31.8449 11.9168 5.4517 +1625 4 10.3518 16.6682 24.8476 5.65772 -8.76316 -0.529027 +1626 6 20.7604 3.23767 6.55488 4.15603 28.9608 0.670607 +1627 4 20.2106 2.56517 6.18958 -7.79877 -24.0058 -5.45951 +1628 4 20.2434 4.04703 6.45055 -2.36445 1.41903 2.77062 +1629 6 47.6381 39.1588 31.2153 -11.506 28.7103 -40.9212 +1630 4 46.7125 39.0803 30.8864 16.1685 3.01672 12.9065 +1631 4 48.0161 39.883 30.6238 -10.851 -36.2784 24.6994 +1632 6 8.33868 27.7571 27.6932 -33.938 3.65348 13.4266 +1633 4 7.90796 26.9962 28.1436 6.90464 18.5991 -0.450451 +1634 4 9.05762 27.3551 27.2376 19.8804 -10.068 -12.1598 +1635 6 33.245 40.3099 33.4253 18.3517 22.2199 -28.9554 +1636 4 32.5937 41.0038 33.2194 0.94932 -12.4457 9.89811 +1637 4 33.9479 40.492 32.7526 -7.59275 -9.33057 17.0692 +1638 6 24.5058 34.6327 27.2588 -1.70215 14.4876 -27.3243 +1639 4 24.8356 35.5409 27.0166 -5.53884 -24.0927 13.0812 +1640 4 24.1351 34.315 26.3934 7.47117 3.95694 29.9195 +1641 6 13.3256 36.76 35.7403 23.371 22.3884 -21.319 +1642 4 14.292 36.6204 35.8687 -19.0607 -2.42845 14.454 +1643 4 12.8134 36.0651 36.1242 -8.79549 -23.1532 9.33092 +1644 6 34.0568 20.1616 33.2139 18.2744 1.49148 -3.34215 +1645 4 34.901 20.3965 32.7524 -27.9907 10.0382 9.43414 +1646 4 33.5726 20.9405 33.5892 13.555 -8.0917 -8.63642 +1647 6 22.8329 33.5616 31.6214 -12.6844 15.5573 -21.5595 +1648 4 23.5755 34.1858 31.5969 1.53708 -3.14405 -0.637663 +1649 4 23.0292 32.8658 32.2325 13.4469 -12.4025 17.113 +1650 6 23.7434 2.42786 19.8498 9.49596 22.5629 12.9133 +1651 4 24.532 1.90722 19.7117 15.1933 -8.07802 -2.32773 +1652 4 23.0629 1.99408 19.3682 -23.4605 -15.8437 -14.4607 +1653 6 10.59 1.63974 20.5169 -0.95575 -6.83071 6.14558 +1654 4 9.98705 1.03236 20.0473 7.71399 2.84727 3.14747 +1655 4 10.6246 2.47233 20.0276 -8.35822 1.7372 -3.87231 +1656 6 6.50082 24.8628 7.81243 5.63459 3.09475 -4.38693 +1657 4 7.40706 24.9537 7.44087 -14.825 -10.0154 1.3351 +1658 4 6.01351 24.1359 7.38457 10.3118 5.93376 -6.27471 +1659 6 54.7907 32.5298 25.4601 2.42441 14.1538 -12.299 +1660 4 54.0693 33.194 25.3949 12.697 -15.3913 -0.923548 +1661 4 0.387469 32.6052 24.6546 -22.4501 -0.197402 25.3904 +1662 6 6.24565 20.1804 28.9699 -20.0835 16.2671 13.5362 +1663 4 5.37616 20.2206 28.5173 17.3942 -4.89439 1.50138 +1664 4 6.85708 19.7029 28.4106 5.94408 -11.9876 -6.03836 +1665 6 50.061 21.6087 11.3404 -11.515 44.0552 -42.0488 +1666 4 50.9725 21.751 11.0493 2.56545 -3.3262 -1.97817 +1667 4 50.0662 20.9568 11.9903 8.13397 -42.2403 36.0281 +1668 6 43.4741 33.5215 19.648 39.1267 -7.16957 -40.9914 +1669 4 43.8052 33.5504 20.5247 -1.27694 2.64583 28.8889 +1670 4 42.5461 33.5822 19.6063 -36.855 5.29583 12.3512 +1671 6 30.8225 7.19458 41.0729 -33.0718 18.8928 10.1641 +1672 4 30.0173 7.64992 40.6345 32.3343 -18.9847 22.962 +1673 4 30.7853 7.47469 0.131591 -1.52838 -8.42988 -38.7943 +1674 6 12.1264 25.8478 11.0965 -41.5825 -1.76886 -24.0951 +1675 4 11.2804 25.9828 10.5746 22.2453 -8.09118 27.7312 +1676 4 12.6111 26.6214 10.8799 25.9351 22.819 -1.42381 +1677 6 47.8207 5.82713 17.7363 28.7614 -16.7343 -8.46055 +1678 4 48.0335 5.15295 17.0353 -2.74159 24.5551 13.4979 +1679 4 48.6986 6.12754 18.0988 -19.3132 -4.26463 -8.98138 +1680 6 35.1697 12.9074 16.5814 -26.6969 23.1645 14.7724 +1681 4 35.331 12.9801 17.5341 9.94288 -5.95548 -5.31324 +1682 4 34.5116 13.6489 16.4838 18.7069 -22.8028 -11.189 +1683 6 10.4746 10.6344 33.9856 -30.1195 -20.4446 -6.31426 +1684 4 10.7944 11.3866 34.5009 -4.55531 -6.56386 0.452866 +1685 4 9.59186 10.377 34.349 25.6427 10.4215 -3.60637 +1686 6 9.86976 7.46809 9.66723 13.2706 -15.2427 -11.6817 +1687 4 9.07254 8.00079 9.6953 0.322066 10.4083 -1.78771 +1688 4 10.1027 7.29929 8.72005 -15.6005 8.2826 19.6359 +1689 6 11.1498 9.5629 29.1446 -4.60031 -6.3451 3.75047 +1690 4 10.6862 9.26798 29.9509 5.10767 2.07156 -10.4371 +1691 4 11.3249 8.76682 28.6116 2.75639 0.845127 6.4689 +1692 6 46.3982 12.7571 37.8973 13.0728 8.65129 -14.0384 +1693 4 46.6651 13.0033 36.9771 -6.5436 -6.98702 17.4091 +1694 4 46.8422 13.384 38.4935 -4.33131 -5.25976 0.421567 +1695 6 4.7745 19.0249 15.9997 -22.3762 2.96494 22.3523 +1696 4 4.16029 19.0173 16.7572 4.82074 7.85299 -8.34635 +1697 4 5.51792 18.5695 16.4006 17.242 -3.98645 -13.636 +1698 6 50.2756 39.8187 19.3535 -48.7732 -19.7782 -8.19609 +1699 4 50.1357 39.0812 19.9713 14.3147 6.83039 4.1366 +1700 4 49.4547 39.7468 18.7938 35.5854 8.27631 5.22634 +1701 6 3.57022 23.2982 26.3116 -7.21736 12.7853 -4.33091 +1702 4 3.04677 23.327 25.4841 2.15403 -9.28995 15.8001 +1703 4 3.1589 23.9918 26.8774 3.27351 -16.4313 -7.87876 +1704 6 43.3323 18.2357 20.5099 -9.76971 -1.121 -6.56922 +1705 4 42.7632 18.9863 20.7177 2.34101 2.93749 0.115163 +1706 4 43.9096 18.122 21.2711 1.48233 -4.92166 7.17918 +1707 6 14.4939 41.5272 19.7194 7.33174 -3.95938 -8.98841 +1708 4 13.9791 41.768 20.4704 -25.804 7.49044 14.4407 +1709 4 15.35 41.4773 20.1189 24.9681 -5.23262 -6.74673 +1710 6 29.2751 29.8624 26.915 55.5011 14.3278 -64.7852 +1711 4 29.462 29.6739 25.9095 -28.0317 9.76644 54.5148 +1712 4 30.1137 30.3565 27.1616 -29.5885 -20.0698 8.89328 +1713 6 6.32585 26.1455 11.5441 3.18215 15.5722 27.8672 +1714 4 6.22913 25.7559 12.4173 -5.87839 -9.43723 6.04013 +1715 4 6.88652 26.9071 11.7431 3.72153 0.148286 -16.8953 +1716 6 27.6581 9.23325 15.2376 24.6795 20.4415 1.81178 +1717 4 28.3906 9.86787 14.9946 -20.7277 -22.2866 6.02651 +1718 4 27.7257 8.49599 14.6233 3.42822 -3.8556 -2.27597 +1719 6 29.7826 38.0629 17.0951 -21.7625 -1.10982 -31.3954 +1720 4 29.5447 37.2807 16.5438 11.5646 7.7876 16.1146 +1721 4 29.1666 38.7512 16.7768 9.10566 -6.75007 12.2127 +1722 6 52.2237 28.7307 4.26632 40.7154 12.5569 -19.536 +1723 4 53.094 28.6942 3.75761 -25.982 6.02481 23.1744 +1724 4 51.8384 27.8718 4.17524 -3.40498 -27.0863 -4.04919 +1725 6 17.1651 16.6761 6.10093 10.0081 29.999 -15.4838 +1726 4 17.0645 17.5224 6.60658 -3.46995 -23.4179 -4.25622 +1727 4 16.9429 15.9406 6.65512 -3.52922 -13.7209 19.1007 +1728 6 36.6584 7.55275 33.426 1.51046 -27.4434 34.6673 +1729 4 36.0562 7.00422 33.9909 9.38132 12.247 -13.9906 +1730 4 36.0891 7.78594 32.7139 -15.8398 12.8789 -25.2624 +1731 6 26.1693 3.13272 9.58463 26.4836 36.1065 -53.3475 +1732 4 26.5189 3.61335 10.3026 12.8321 10.8542 33.1136 +1733 4 25.6805 2.43597 9.90138 -37.6231 -51.1462 30.1839 +1734 6 1.19232 17.1076 33.1734 0.722887 26.1228 -9.87087 +1735 4 1.0219 17.7977 32.4875 3.44775 -13.3597 11.6369 +1736 4 0.89275 17.4757 34.0242 -0.842403 -4.58413 -3.86686 +1737 6 29.175 10.1805 5.37687 2.48705 -7.47299 -1.58449 +1738 4 28.5307 10.3443 6.0806 2.54341 -1.49901 -0.102048 +1739 4 29.6529 9.35261 5.56356 -13.9845 3.47491 -0.693848 +1740 6 9.21964 21.135 0.193729 30.6013 -8.57211 -16.2038 +1741 4 9.93935 20.7152 41.5745 -5.21063 7.9265 20.924 +1742 4 8.4582 20.7874 41.6647 -18.4316 -1.36421 1.54976 +1743 6 7.41915 26.897 34.8578 6.273 24.0322 40.4596 +1744 4 7.07209 27.1094 35.7714 11.2799 -9.18849 -34.7736 +1745 4 6.87885 26.1925 34.5434 -18.5272 -22.724 -11.5995 +1746 6 18.6237 10.1563 3.02822 -55.9716 37.9013 1.68891 +1747 4 17.9823 9.44023 2.87563 14.9297 4.34306 1.98909 +1748 4 18.009 10.9755 3.18254 40.8652 -32.8317 -2.61569 +1749 6 13.1455 21.2337 25.2154 -14.3081 5.93545 -14.9534 +1750 4 12.8153 21.6822 24.4216 9.6722 -4.26313 4.93127 +1751 4 12.7862 20.3541 25.1726 -3.49479 -14.4912 -0.313259 +1752 6 4.91031 24.4198 40.532 -13.7809 -26.5024 -53.169 +1753 4 5.65778 24.4539 41.0894 26.3299 12.2697 26.6549 +1754 4 5.26856 23.9753 39.7091 -18.4358 16.5303 24.5031 +1755 6 54.7198 6.2862 9.93073 18.558 2.67796 -18.7732 +1756 4 54.1336 6.00192 10.611 -15.308 -5.80798 23.6242 +1757 4 0.005563 7.17106 10.1764 0.43073 7.36928 5.10877 +1758 6 51.7604 16.6436 19.3877 -20.3234 -7.55047 -14.8495 +1759 4 51.6779 16.1639 18.5383 1.1676 14.9854 4.84802 +1760 4 52.2077 17.4816 19.2574 16.3674 3.30585 -9.00164 +1761 6 38.6218 2.96001 13.0988 15.7387 3.67705 55.5859 +1762 4 38.6299 3.43096 13.9849 -4.06073 -12.9308 -23.724 +1763 4 38.2169 3.56793 12.5083 -12.8186 19.7945 -24.9943 +1764 6 19.4471 35.7007 9.61167 2.35324 -8.95281 6.35471 +1765 4 18.8335 36.2871 9.19379 -17.9936 2.63552 -14.7984 +1766 4 18.9495 35.3837 10.3842 8.56204 6.47345 -9.11173 +1767 6 46.9457 37.6212 25.7021 -15.6754 4.57489 10.5165 +1768 4 47.0239 38.0262 24.8354 11.6036 -0.197794 -10.4287 +1769 4 47.7281 37.1166 25.9279 8.14222 -0.129186 -6.11913 +1770 6 20.0249 17.2708 14.7582 9.34392 -2.11639 -6.02108 +1771 4 19.1723 17.4786 15.1706 12.7461 -0.873648 3.80655 +1772 4 20.7009 17.0069 15.4035 -13.3418 2.74043 0.572405 +1773 6 24.7358 29.2923 3.78206 18.5642 -33.4808 -47.1325 +1774 4 24.7422 28.3915 3.3709 -13.1038 11.8323 28.3161 +1775 4 25.3506 29.6775 3.14782 -2.77927 21.1078 10.4189 +1776 6 3.43141 8.92567 6.82668 25.8011 -1.75535 29.9445 +1777 4 3.08486 8.82716 7.75964 16.0017 4.22665 -30.6726 +1778 4 4.42441 9.10783 6.89545 -42.5611 -5.30748 1.54274 +1779 6 17.4891 30.59 19.7026 37.1524 -11.5388 -6.241 +1780 4 18.4343 30.3591 19.4199 -38.2372 10.1448 10.4771 +1781 4 16.9657 29.7875 19.5831 -4.14236 3.18225 -9.29444 +1782 6 13.2748 16.1833 39.0603 8.39615 -10.6604 2.01333 +1783 4 13.778 16.9491 39.3364 8.93523 3.59341 7.63718 +1784 4 12.5498 16.5465 38.5646 -17.693 7.52452 -10.3405 +1785 6 23.8419 27.9652 11.5971 -29.0622 15.8949 5.8355 +1786 4 23.0433 27.5239 11.9581 15.8216 -1.64981 -8.50246 +1787 4 23.6687 28.8945 11.8451 9.38175 -9.8305 -3.59643 +1788 6 14.4582 24.411 21.2251 -13.2323 27.0215 19.0701 +1789 4 13.9163 25.2229 21.3861 13.2503 -9.35589 -12.2275 +1790 4 14.348 23.9323 22.0593 -1.27999 -3.95586 -5.82862 +1791 6 46.6209 15.1404 22.2877 -21.0909 8.30909 34.5316 +1792 4 45.8336 14.7024 21.9608 7.3328 -3.88381 -14.3297 +1793 4 47.2246 15.4169 21.6106 10.5055 -5.27886 -22.0515 +1794 6 19.1453 29.7169 11.8746 -27.0123 -18.8736 -35.9167 +1795 4 18.7667 30.5363 11.5796 10.8323 29.6783 4.39578 +1796 4 18.5214 29.1838 11.3275 23.3568 -13.7991 20.8336 +1797 6 36.9132 18.8016 27.615 -17.0652 -23.8487 30.8874 +1798 4 36.4034 18.4868 26.8464 6.26881 1.65463 6.80847 +1799 4 36.6041 18.1666 28.3506 10.215 31.7365 -33.4968 +1800 6 35.8839 17.5137 25.5036 -5.81764 30.7264 -16.7466 +1801 4 36.5665 17.9094 24.9 -10.7703 -22.5287 9.19997 +1802 4 35.9135 16.5474 25.44 8.68204 5.15754 -2.43364 +1803 6 8.04468 41.8981 31.5366 26.4021 9.77217 -3.38911 +1804 4 8.66886 41.284 31.9946 -24.4733 15.0027 -13.0466 +1805 4 8.60227 0.704634 31.1522 -11.4596 -14.2431 6.13083 +1806 6 31.7024 34.8356 17.9299 26.5575 -27.0845 -4.88708 +1807 4 32.6196 34.4986 17.7931 -22.3662 0.836155 -3.84042 +1808 4 31.9071 35.6664 18.3392 -5.09232 26.8034 6.09861 +1809 6 22.0993 41.0535 5.13739 10.0927 40.3608 -89.4928 +1810 4 22.1435 40.6782 5.94278 2.96748 -46.7441 88.004 +1811 4 22.8097 40.6452 4.60918 -8.49191 2.25551 6.5005 +1812 6 11.6188 5.17183 29.5438 -37.4391 -17.3681 45.4318 +1813 4 12.0782 4.3477 29.7115 12.4576 1.56532 -11.0695 +1814 4 10.8376 5.06958 30.1835 21.3256 14.0691 -33.8944 +1815 6 13.0142 9.45267 21.0738 -17.3871 -39.5803 -33.4019 +1816 4 13.648 9.91302 21.5572 37.1542 33.3127 26.6408 +1817 4 13.4951 8.71823 20.6397 -14.9934 11.5246 2.17133 +1818 6 12.4259 4.16416 0.171584 25.5917 58.0572 -18.9009 +1819 4 12.7038 3.75631 0.988868 -0.121161 -3.62646 8.37405 +1820 4 12.9914 5.02921 0.073462 -27.1162 -49.1387 2.0493 +1821 6 45.1548 14.6294 28.1056 43.5869 -15.7342 -2.79686 +1822 4 45.3799 14.9442 27.2254 -14.4652 2.82802 -6.08545 +1823 4 46.001 14.1543 28.294 -26.1128 6.03561 5.66217 +1824 6 52.5819 19.2522 0.880939 -13.6546 -24.4625 3.21793 +1825 4 52.4967 19.3157 41.8353 6.16951 -6.72877 -2.3034 +1826 4 52.7342 20.1258 1.1855 8.55196 28.2584 6.16427 +1827 6 0.17636 18.5769 30.5692 -13.5341 -21.3209 11.3545 +1828 4 0.97347 18.6538 30.0344 3.16555 8.74201 -0.550561 +1829 4 54.7381 19.4288 30.6755 1.51483 11.9419 -1.05075 +1830 6 17.6474 28.1849 1.96582 -3.95698 7.79984 2.09024 +1831 4 17.0036 28.8884 1.72628 7.01161 -11.1903 7.18073 +1832 4 17.5665 28.0879 2.93205 1.48476 5.36119 -8.9874 +1833 6 22.5179 30.1562 5.01973 -0.557011 13.5756 -11.2394 +1834 4 23.053 30.1464 4.21842 7.71181 1.56353 5.86697 +1835 4 22.1417 29.2826 4.9966 -11.5089 -8.75783 6.0437 +1836 6 11.3992 8.80614 17.6425 18.8049 17.2909 -5.92301 +1837 4 12.0044 8.1818 18.0403 -8.94801 -14.7479 17.6102 +1838 4 12.0653 9.44286 17.3244 -18.8797 1.15675 -4.46111 +1839 6 32.2825 3.5901 26.8335 38.6865 42.7422 0.354813 +1840 4 31.9744 3.38447 25.9652 -16.937 -9.17442 -22.5821 +1841 4 32.8531 4.41036 26.697 -18.7333 -32.0278 -1.10411 +1842 6 26.8283 37.1448 15.664 9.9544 44.9512 -6.81835 +1843 4 26.832 37.6522 16.5019 -4.80771 -22.2764 -7.00776 +1844 4 26.708 36.2069 15.7377 -4.77442 -21.1488 11.5765 +1845 6 22.9466 3.40402 22.281 26.551 -3.46013 -1.27592 +1846 4 23.3626 3.00539 21.4748 -15.0613 6.75 14.6032 +1847 4 23.702 3.67884 22.8406 -14.5661 -4.86975 -12.1571 +1848 6 14.6187 28.2219 5.2011 12.2375 -1.31522 5.54773 +1849 4 14.146 28.1316 4.37141 -5.71124 1.87741 -8.30492 +1850 4 14.2863 29.0052 5.66137 -0.824291 -0.470469 -2.06805 +1851 6 20.2555 37.1856 16.5486 -24.9193 16.4856 21.7008 +1852 4 21.0596 37.4718 16.144 26.6499 6.5165 -11.4453 +1853 4 20.1477 37.8155 17.2956 -4.48599 -12.7862 -6.90992 +1854 6 17.9469 28.5629 23.8891 26.0841 -15.2841 -12.8531 +1855 4 18.7956 28.2639 23.4837 -20.5944 5.95667 14.8805 +1856 4 17.3322 27.8283 23.7208 -3.07308 9.52654 -1.59768 +1857 6 33.6454 24.2344 25.2281 6.08515 -19.3492 9.67379 +1858 4 33.7229 23.2583 25.1621 -7.7165 13.5894 -11.682 +1859 4 33.9838 24.3464 26.1231 0.527101 9.69022 -3.14208 +1860 6 9.99248 17.6305 2.22889 -2.94775 -31.1618 -12.577 +1861 4 10.7668 17.5307 1.6348 -7.17319 1.58445 12.7603 +1862 4 9.8062 16.7546 2.64219 6.61617 15.6433 -4.64734 +1863 6 24.3378 36.7975 8.92134 10.0949 -17.5556 18.6285 +1864 4 24.0798 37.5812 8.46711 -7.4438 24.0622 -5.98172 +1865 4 24.7733 37.0584 9.7453 -6.84359 -4.10885 -5.58351 +1866 6 14.3929 4.30304 27.7402 56.7365 -3.53996 19.7179 +1867 4 15.3546 4.44499 27.4586 -37.3153 -7.57895 7.00929 +1868 4 13.8272 4.37832 26.9899 -16.116 5.01688 -19.8092 +1869 6 13.2096 25.4586 35.3298 -3.87145 -6.51473 -10.8119 +1870 4 13.1476 25.2267 36.278 -1.83966 -3.78777 -13.8323 +1871 4 12.5545 24.9939 34.7684 5.09589 5.85633 19.2997 +1872 6 43.7315 33.1816 24.4051 17.2004 -9.02075 24.8986 +1873 4 44.3591 33.0681 25.1678 -20.1541 -6.26738 -17.3644 +1874 4 44.1096 33.9146 23.9227 -1.6352 8.32092 -8.69406 +1875 6 6.97009 30.4077 7.13769 23.121 1.43384 34.0809 +1876 4 6.71282 29.9591 7.9596 7.06976 3.62274 -2.26904 +1877 4 6.20421 30.2819 6.61977 -27.9511 -2.76807 -27.2062 +1878 6 44.437 39.4145 21.7835 -9.43682 11.6365 -18.5611 +1879 4 43.878 39.1032 21.0489 1.92512 -11.9494 17.5009 +1880 4 44.878 40.1639 21.3648 8.44417 -6.89071 6.17346 +1881 6 1.1648 16.4475 24.9778 -2.61131 5.39938 13.1681 +1882 4 1.07525 17.0286 24.1819 -7.88043 -13.0173 22.3573 +1883 4 0.434843 16.5677 25.6378 18.4556 1.9359 -28.7216 +1884 6 8.16988 33.8361 10.6637 16.6829 23.9256 47.7562 +1885 4 8.49559 33.5478 9.83195 -4.50358 -22.2449 -29.7436 +1886 4 7.35799 33.4028 10.9227 -18.4601 -13.1254 -8.86092 +1887 6 45.3716 15.8699 40.491 -6.36942 -3.03704 -2.15917 +1888 4 44.5133 15.7719 40.0601 4.63234 -6.98635 -0.416374 +1889 4 45.243 16.6248 41.0649 5.7116 1.92459 5.42472 +1890 6 38.7776 4.29245 15.9056 11.0795 0.30753 4.41463 +1891 4 39.6766 4.00679 16.0952 1.69097 -2.92337 -3.33067 +1892 4 38.5504 4.73291 16.7401 -7.14778 -2.92142 -9.36231 +1893 6 21.0846 9.20759 23.9691 5.60032 -0.18462 4.18544 +1894 4 20.9445 8.65571 23.1711 -3.69603 16.8592 7.46004 +1895 4 20.5672 10.0363 23.9442 1.93643 -14.5945 -11.3561 +1896 6 6.46938 36.1391 20.0069 4.0004 4.10087 4.13062 +1897 4 5.99357 35.3124 19.8297 -2.3473 7.0562 -2.30419 +1898 4 7.3052 35.893 20.4098 -0.600933 -5.92452 -3.30983 +1899 6 17.7588 23.4635 11.2444 16.528 -28.2646 53.7307 +1900 4 16.9432 23.8548 11.0264 -32.805 26.4079 -23.7501 +1901 4 17.621 23.3206 12.2167 9.32529 -0.814156 -28.2078 +1902 6 2.23938 39.2705 23.5372 32.4488 -19.3396 -21.3039 +1903 4 2.96143 39.1072 24.212 -19.8533 -4.03587 -26.9428 +1904 4 2.57592 39.0525 22.6024 -11.4643 11.6849 46.2914 +1905 6 21.7189 10.3135 3.08585 -2.90529 19.7604 61.578 +1906 4 21.843 10.1221 2.19424 -0.974385 -17.6276 -55.1642 +1907 4 20.7734 10.4085 3.28686 2.80557 -4.86174 -11.6796 +1908 6 13.3371 37.6485 26.8148 34.7445 -2.08205 -3.58175 +1909 4 12.7942 37.01 27.2655 -5.666 -15.7112 8.11946 +1910 4 14.1995 37.1812 26.5945 -31.1056 12.6209 6.4215 +1911 6 45.679 9.86525 8.82671 -1.22844 -5.97168 -0.0165319 +1912 4 45.3204 9.57969 7.98479 1.29945 7.51218 -9.52666 +1913 4 45.2548 9.27624 9.44517 -6.37871 -3.09075 9.62419 +1914 6 39.8117 32.343 29.5858 -3.04799 14.0722 -9.88422 +1915 4 39.6223 31.4471 29.2796 3.58631 -7.81261 7.71305 +1916 4 40.3439 32.3214 30.3816 0.770365 -10.1242 2.16071 +1917 6 39.1301 32.1592 8.96473 45.9624 -7.76569 -23.2306 +1918 4 39.6852 32.0596 8.1252 -31.4186 4.60772 35.1501 +1919 4 38.2007 32.2042 8.75798 -9.66602 0.778467 -8.76952 +1920 6 29.7501 11.3103 40.3404 42.6438 -12.6008 -10.1865 +1921 4 29.0692 10.6634 40.5326 -1.99158 -8.72077 -0.363163 +1922 4 30.6164 10.7842 40.3158 -34.6338 15.486 -0.0451708 +1923 6 24.8345 19.8801 29.8412 -7.59088 37.7695 16.0848 +1924 4 24.9026 19.0378 30.268 -1.65451 -21.4471 9.48031 +1925 4 24.5694 20.5293 30.547 8.64688 -23.6335 -15.2845 +1926 6 50.0799 29.4689 2.86832 11.3398 7.37373 -14.0975 +1927 4 50.7937 29.3382 3.51213 -5.95266 6.62042 -8.33887 +1928 4 50.5172 29.4209 1.98721 -16.9062 -3.16045 21.5768 +1929 6 26.3158 13.2487 37.9516 44.6834 6.62304 1.7852 +1930 4 27.2667 13.2121 37.7291 -19.4356 -10.4808 -19.3263 +1931 4 26.4654 13.336 38.8817 -25.2145 10.5198 25.1195 +1932 6 24.3285 13.817 16.1492 -2.87417 -29.0242 -9.8062 +1933 4 24.8278 14.0306 16.9324 2.95884 13.8503 11.1204 +1934 4 24.1796 14.5912 15.6032 1.91347 13.6823 2.96602 +1935 6 21.9624 25.0824 8.00452 15.4008 12.078 14.6814 +1936 4 22.598 25.7039 7.58094 -6.50256 -15.9793 3.04336 +1937 4 22.4506 24.6482 8.74092 -7.92214 9.81208 -17.5113 +1938 6 50.1646 25.295 29.0323 7.20414 -13.325 -13.2678 +1939 4 50.9752 25.188 28.522 -3.46618 -9.57224 -11.582 +1940 4 50.4808 25.9292 29.6536 -4.58067 20.151 23.6328 +1941 6 23.186 6.81871 7.63171 8.52809 43.4321 -4.70249 +1942 4 24.005 7.36604 7.81791 -26.2659 -19.6382 -4.15731 +1943 4 22.4749 7.49932 7.50679 12.9101 -23.886 0.0924589 +1944 6 6.93738 5.85096 20.8328 -1.25739 23.0019 -5.42089 +1945 4 7.49016 6.65136 20.6793 -8.05782 -22.0664 2.33926 +1946 4 6.43567 5.73489 20.0135 6.68134 -11.6114 -0.0369962 +1947 6 25.4027 39.7503 23.9523 -6.31967 32.2782 -31.5462 +1948 4 25.6215 38.8259 24.0292 3.86532 -10.8289 -5.32001 +1949 4 25.5293 40.0494 22.9984 1.78505 -20.5244 33.6821 +1950 6 10.8465 30.682 2.12076 -14.9417 -4.95607 29.3443 +1951 4 9.91334 30.8811 2.27771 3.65307 -4.25506 9.47201 +1952 4 11.0492 31.2188 1.38489 10.4343 12.2811 -36.8692 +1953 6 23.0846 40.5263 40.0577 -14.1833 12.856 -13.2149 +1954 4 23.7732 40.7716 39.4116 -4.4893 -4.99974 3.24897 +1955 4 22.2685 41.0049 39.7737 14.5189 -12.3092 -2.05606 +1956 6 29.2062 28.3669 37.5673 -46.9973 46.4688 -26.4511 +1957 4 28.2092 28.447 37.3765 47.4284 -5.55714 9.99444 +1958 4 29.3363 27.5265 37.9547 9.31284 -31.0764 15.334 +1959 6 1.86163 12.1711 18.0765 -5.91003 5.49035 -5.71632 +1960 4 2.55659 11.9166 18.6527 25.6221 -14.4574 8.12849 +1961 4 1.26079 12.5379 18.7153 -20.6967 6.08864 -3.03965 +1962 6 35.8475 14.1052 8.57203 -21.6385 -0.893463 -33.3774 +1963 4 35.1968 13.4152 8.63145 -9.00219 -13.9675 31.2536 +1964 4 35.5915 14.3843 7.67264 23.8052 12.2531 2.11843 +1965 6 9.47935 39.8135 37.5891 59.0759 6.31763 -30.1219 +1966 4 10.4266 39.6693 37.2666 -35.8633 -8.68454 26.4626 +1967 4 9.26489 40.5592 37.0217 -20.4655 -4.29881 5.22341 +1968 6 3.55142 30.3339 19.2713 -4.86381 -1.52132 15.3498 +1969 4 4.33638 30.9045 19.2209 2.57405 -7.87202 3.73908 +1970 4 3.61239 29.7873 20.0935 6.99099 14.0083 -17.3235 +1971 6 36.3358 32.3745 17.56 -88.747 -21.2483 -18.3477 +1972 4 37.1123 32.7301 17.855 71.5568 29.0637 22.2427 +1973 4 36.4955 31.7908 16.8209 7.92507 -6.87638 -5.35096 +1974 6 22.0663 24.5107 41.4102 10.2987 16.3962 12.7497 +1975 4 21.8202 25.2352 0.099599 7.35269 -2.74787 -1.24985 +1976 4 21.4331 24.5495 40.7007 -15.7672 -0.145359 -12.6123 +1977 6 45.7559 15.6146 11.6534 9.54961 -0.52573 -11.8143 +1978 4 46.6616 15.9476 11.7359 -2.85604 3.39399 3.95489 +1979 4 45.8337 14.6574 11.6049 5.18085 -12.4794 -2.56515 +1980 6 22.3677 20.3608 16.0248 -8.43349 0.762232 -3.33301 +1981 4 21.8453 20.4382 16.8206 -16.1556 -9.64869 10.2413 +1982 4 23.0114 21.0388 16.1556 20.3116 20.3082 3.24798 +1983 6 25.8272 25.7408 18.9039 -4.38174 23.1082 -8.64826 +1984 4 25.2526 26.4897 18.6396 10.1677 -11.9346 2.39614 +1985 4 25.327 25.3554 19.6213 -1.60311 -10.6753 3.35926 +1986 6 35.3217 34.2027 33.2895 -15.2368 -41.9721 4.95923 +1987 4 35.4982 35.1152 33.2737 3.10328 43.0158 -1.14622 +1988 4 34.4946 34.1251 33.8 0.780353 -3.85018 -10.6306 +1989 6 39.2773 17.1161 17.3873 -13.1248 -32.2738 -8.05101 +1990 4 39.9918 17.6798 17.5739 28.094 23.6652 8.23643 +1991 4 38.688 17.6273 16.829 -11.1713 3.07886 5.75329 +1992 6 0.390078 14.9382 21.7871 11.1367 4.76555 -0.935352 +1993 4 54.4387 14.8735 21.5807 -4.47162 2.48431 -1.07762 +1994 4 0.539841 14.2564 22.4568 -0.558284 -6.24417 -4.29591 +1995 6 15.9777 23.2264 17.7728 8.65625 13.1041 -6.34263 +1996 4 15.4566 22.9884 16.9791 5.52796 1.00784 5.82867 +1997 4 16.2806 24.159 17.6616 -10.6082 -13.1932 5.11686 +1998 6 5.23931 11.1231 17.5575 35.8701 -10.5445 17.9772 +1999 4 4.9182 10.2425 17.6538 -30.0926 -10.858 -8.95801 +2000 4 6.0864 10.9521 18.0214 -7.64643 27.0942 -5.06777 +2001 6 9.32885 36.7248 13.2722 18.9931 -22.2768 -8.23823 +2002 4 9.60165 35.7781 13.2295 -3.69965 14.6724 -0.704445 +2003 4 9.76236 37.1699 12.5317 -7.58045 -2.70049 0.515103 +2004 6 25.4778 33.5648 0.584885 -10.5355 67.2754 -12.4068 +2005 4 25.5984 34.5208 0.879361 -11.6997 -30.6233 -9.64051 +2006 4 26.086 33.1118 1.1181 20.4991 -31.2317 29.3626 +2007 6 17.3118 24.383 31.3319 -1.28664 6.54307 -2.76395 +2008 4 17.7194 25.1777 30.9449 -5.40799 -4.17061 0.343513 +2009 4 16.6541 24.6578 31.9842 -4.89885 3.77294 -0.581941 +2010 6 50.5608 32.7082 27.7934 4.54158 -2.94952 -18.7634 +2011 4 50.7453 32.9177 28.6973 0.494052 11.2961 18.8161 +2012 4 49.6536 32.9735 27.676 -15.0266 -0.0998574 -2.84245 +2013 6 2.26734 37.236 16.1173 -6.42813 -12.7591 -21.9136 +2014 4 3.23226 37.3187 16.1136 -7.03488 -2.64717 4.42174 +2015 4 1.90002 37.4962 16.9584 8.86323 8.39289 12.7736 +2016 6 25.781 33.1953 8.40059 -29.5389 -21.3471 9.61313 +2017 4 24.912 33.1588 8.86731 13.6407 4.32372 -10.5279 +2018 4 25.7521 32.4014 7.84509 3.14784 4.30114 -1.53431 +2019 6 24.7803 7.83271 25.42 33.5144 32.018 13.9598 +2020 4 25.5535 8.29724 25.0002 -28.4293 -10.6828 16.5011 +2021 4 24.3491 7.42211 24.7041 -24.9556 -17.4551 -27.4815 +2022 6 44.0168 27.3303 21.5604 -2.1935 -26.0293 -25.9567 +2023 4 43.1804 27.7287 21.7105 -15.5436 25.6402 11.6584 +2024 4 43.7182 26.5374 21.0766 16.4483 6.01939 6.04345 +2025 6 20.8314 32.075 6.72772 34.1297 -23.9008 -4.85338 +2026 4 21.613 31.4679 6.7544 -19.7741 14.5872 -14.4381 +2027 4 20.6476 32.1788 7.6576 -7.69651 14.1485 11.3249 +2028 6 0.619789 26.0994 3.99415 -10.3518 14.1264 10.767 +2029 4 0.887335 25.4928 3.30986 5.36048 -13.1936 -7.97543 +2030 4 1.24971 25.9998 4.71308 0.85353 -1.82089 -1.56654 +2031 6 23.69 0.227417 22.8544 35.0871 1.11343 17.3571 +2032 4 23.3906 1.11513 23.0752 -8.28129 -2.57498 -6.74336 +2033 4 24.6181 0.214091 23.2237 -29.0994 -2.98435 -11.3486 +2034 6 35.6339 26.9438 6.46453 10.8918 50.3879 3.14258 +2035 4 36.2586 27.0344 7.19591 -3.09793 -24.7425 -0.485193 +2036 4 35.6905 27.8753 6.10871 -13.1004 -35.3011 6.52721 +2037 6 50.1792 7.09321 18.6927 -10.3798 0.485236 0.91939 +2038 4 50.7755 7.39768 17.9917 2.23399 -7.26744 -1.07457 +2039 4 49.6856 7.89728 18.8977 2.66313 1.30029 -2.34319 +2040 6 12.4725 14.8259 12.1994 -11.4238 -12.6169 14.8051 +2041 4 11.6664 14.488 12.6556 18.5487 5.78377 -7.93059 +2042 4 12.1518 15.362 11.4889 -6.75978 6.85562 -13.2996 +2043 6 52.4644 22.357 36.3266 1.29806 9.96622 10.4358 +2044 4 51.6029 21.898 36.3064 11.3287 0.910024 -15.7837 +2045 4 53.0734 22.0059 35.6434 -17.6122 -2.36697 5.80151 +2046 6 41.7741 11.4843 39.1248 -4.39753 -8.31887 -97.8346 +2047 4 42.1028 11.6824 39.9378 27.3537 17.7413 77.2645 +2048 4 42.4804 11.7867 38.4877 -22.5072 -9.73773 16.9601 +2049 6 13.8016 22.5118 39.1095 -61.9889 -17.7515 -30.6487 +2050 4 12.8197 22.2903 39.2632 45.6803 12.2331 1.0283 +2051 4 13.898 22.318 38.1378 10.5436 5.15112 27.5343 +2052 6 28.757 19.5278 21.8422 22.1809 -34.574 6.30338 +2053 4 29.5381 18.8977 21.7155 -30.335 22.4331 6.48321 +2054 4 28.5907 19.9346 20.9925 4.65837 4.37905 -10.6157 +2055 6 8.3499 21.6369 36.3971 -4.18721 -6.14707 -6.4426 +2056 4 8.67403 22.5346 36.3601 -3.60933 11.4321 4.1017 +2057 4 7.70004 21.5677 37.1222 1.54916 7.87236 -6.53046 +2058 6 39.9526 23.9745 15.2115 13.6309 -13.3423 -31.903 +2059 4 40.8439 23.5703 15.3899 -24.3155 14.8143 -11.3375 +2060 4 39.7878 23.9253 14.2154 4.70535 3.62281 36.021 +2061 6 8.1527 38.6897 22.5283 9.69445 13.3876 41.2978 +2062 4 7.76273 39.4363 22.0797 -11.7526 5.15604 -12.9046 +2063 4 8.4358 39.1168 23.3873 -5.25998 -17.8667 -18.7912 +2064 6 10.8496 20.1728 28.9641 16.4592 -1.26099 15.6701 +2065 4 9.98954 19.7606 29.0198 -7.88942 -4.93169 1.40711 +2066 4 10.9743 20.477 28.0788 -3.54014 6.836 -18.3013 +2067 6 36.8958 23.8215 41.8184 -11.2791 50.4956 -15.8947 +2068 4 37.6092 23.2626 0.106032 31.5333 -36.7229 14.8491 +2069 4 36.0533 23.398 41.8576 -15.1401 -19.7994 6.87638 +2070 6 23.7844 40.6753 33.3645 25.4398 -8.90266 -26.6636 +2071 4 23.0047 40.9559 33.8219 -17.4738 3.31201 10.6553 +2072 4 23.8864 39.707 33.5122 -4.88896 17.7845 5.86364 +2073 6 4.67086 19.2968 35.4027 23.2175 14.2952 24.1117 +2074 4 5.52557 19.1329 35.8895 -25.1286 -0.194605 -14.6261 +2075 4 4.47498 18.5363 34.8535 5.06934 -11.7578 -4.1199 +2076 6 9.45318 25.7818 10.8943 -12.0967 -8.54473 -2.48434 +2077 4 9.17249 24.8577 10.8042 5.18757 -1.88658 7.00696 +2078 4 8.69489 26.2739 10.5541 4.04726 3.8113 4.64502 +2079 6 27.2856 22.4903 13.6084 -4.27813 -9.26261 -11.4963 +2080 4 27.1477 21.7546 14.2243 0.799228 0.372191 -1.31996 +2081 4 27.4324 22.0688 12.7356 2.14896 10.5831 15.5277 +2082 6 41.0369 18.7679 23.2817 21.3973 -17.1333 -11.6606 +2083 4 40.4805 18.1775 22.7581 -1.93352 7.79722 7.02989 +2084 4 40.5302 19.4817 23.6332 -16.07 12.1618 6.58845 +2085 6 46.4867 28.3511 20.139 19.5633 -2.73425 79.1757 +2086 4 45.7489 28.0125 20.7058 1.11057 9.83041 -23.9354 +2087 4 47.2126 28.3766 20.859 -22.6454 6.05643 -47.0217 +2088 6 14.8422 15.3983 30.0672 9.57922 -13.7488 21.5316 +2089 4 14.7114 15.4303 29.1407 -5.18406 2.12307 -31.6519 +2090 4 14.4223 14.5569 30.327 1.67929 11.6926 7.32181 +2091 6 23.5155 24.7614 35.2027 10.8097 10.1661 11.7756 +2092 4 22.8249 25.3921 35.4883 8.74662 -8.07224 -2.50931 +2093 4 24.264 24.8574 35.8273 -14.1502 1.20627 0.95778 +2094 6 19.9045 24.2066 28.4368 -7.08314 38.6572 -15.5481 +2095 4 20.1199 25.09 27.9887 -7.53461 -31.417 18.3002 +2096 4 18.948 24.2479 28.615 8.77669 -1.27719 -1.90381 +2097 6 45.9703 7.63062 20.2339 -9.12647 -14.8446 45.7383 +2098 4 46.0314 7.87281 21.2057 4.66889 -10.1155 -32.2433 +2099 4 46.2124 8.39508 19.7344 6.23892 21.3693 -9.48098 +2100 6 38.0366 12.4686 8.28298 -82.8488 23.4696 -21.0017 +2101 4 37.3097 13.1608 8.47894 48.7672 -25.4087 1.47773 +2102 4 37.4891 11.9231 7.63396 42.6716 2.94367 19.7224 +2103 6 46.9352 18.181 8.45984 -29.3266 9.95329 16.0714 +2104 4 46.1825 17.5598 8.49993 9.84889 1.25457 2.04897 +2105 4 47.3911 17.9594 7.65971 14.7535 -7.6497 -21.4463 +2106 6 10.8592 13.9727 9.37152 -3.14543 -2.30259 -2.26695 +2107 4 10.3309 14.6626 8.91794 11.6563 -8.1882 2.6931 +2108 4 11.7607 13.9013 8.99546 -12.5287 13.781 2.06755 +2109 6 34.3902 5.43491 14.0826 12.6346 -17.837 -1.14204 +2110 4 35.1666 5.80709 13.6695 9.45544 21.1547 -1.41353 +2111 4 34.3397 4.58795 13.6148 -10.7305 -5.41844 9.88093 +2112 6 0.19016 0.223418 22.9526 3.77382 -24.7853 -3.01602 +2113 4 0.21308 41.6498 22.1069 2.59646 7.80057 12.2766 +2114 4 54.882 1.08863 22.7473 -12.4607 27.7599 -7.08256 +2115 6 40.9349 30.5562 37.8906 -27.573 -19.5948 34.9696 +2116 4 40.0494 30.8463 38.2359 23.4276 0.414778 -20.0189 +2117 4 41.1198 29.7844 38.4793 13.2677 19.1991 -19.1849 +2118 6 16.6358 17.3088 12.6818 26.7235 26.3695 -9.20965 +2119 4 16.2617 16.4703 12.4231 -8.92935 -8.7699 -0.695474 +2120 4 17.0088 17.6771 11.8494 -7.35458 -7.68048 15.4997 +2121 6 29.681 5.43286 24.7605 9.99716 1.48249 -7.0405 +2122 4 30.3348 5.91815 24.2382 -0.696307 0.629534 -2.6419 +2123 4 30.0075 5.55596 25.6632 -4.07672 -1.78023 1.29455 +2124 6 49.8902 0.287541 27.2058 21.9743 -13.7053 4.20571 +2125 4 49.8511 0.519591 26.2742 -5.37584 5.48457 -4.26768 +2126 4 50.7946 41.8257 27.2858 -12.157 4.98657 1.57708 +2127 6 31.2412 31.7366 15.2127 13.4193 29.9729 -4.01619 +2128 4 31.644 30.8863 15.3566 3.05611 -13.2507 6.82249 +2129 4 31.9953 32.37 15.1128 -22.0385 -12.9049 3.52444 +2130 6 35.7903 24.1511 16.9464 13.6459 1.10276 -6.74723 +2131 4 35.6731 24.9832 16.4455 1.01595 -13.8109 1.97492 +2132 4 36.7089 23.8312 16.7527 -22.9866 2.97508 8.81266 +2133 6 24.2751 4.63968 36.7374 -16.5997 -22.3051 -33.4925 +2134 4 24.7608 5.22686 37.2962 14.6544 10.0168 10.4919 +2135 4 24.7016 4.68474 35.8573 -7.94113 -0.389021 16.9181 +2136 6 17.5636 12.9031 3.65869 27.6744 1.86844 -28.0383 +2137 4 17.6858 13.5605 2.94059 1.9993 -16.4932 11.4828 +2138 4 16.8984 13.3068 4.18363 -27.8054 1.98581 18.3397 +2139 6 4.17446 14.2934 18.2709 12.2351 -24.5699 -15.5283 +2140 4 4.25201 13.3082 18.1842 -5.45348 23.7329 4.34334 +2141 4 3.28482 14.5076 18.5604 -13.4286 -3.54266 5.37394 +2142 6 19.1793 36.8557 22.3908 -6.26797 4.12828 -2.16449 +2143 4 18.7803 36.3059 23.064 -4.74301 -7.71326 18.3965 +2144 4 19.5341 36.2254 21.7686 7.87239 -11.0625 -9.31555 +2145 6 15.659 11.9578 13.1999 9.98626 24.0921 3.91449 +2146 4 15.6233 12.8387 12.7526 3.08695 -23.3335 12.0049 +2147 4 16.532 11.8904 13.6603 -13.5492 -1.68197 -15.0215 +2148 6 24.7583 21.9129 5.36621 -52.0449 4.43235 28.4012 +2149 4 24.9756 21.6947 6.28233 10.5491 3.37037 -1.58044 +2150 4 23.7611 21.9216 5.43181 35.5612 -5.35731 -13.8865 +2151 6 52.741 18.5708 35.2268 19.1809 2.02674 5.12186 +2152 4 52.5591 18.101 34.4104 -23.468 -7.47943 -3.72799 +2153 4 51.9957 18.6447 35.8177 -20.5936 -5.49273 0.0575333 +2154 6 3.56038 27.2788 25.2921 -16.6903 -17.6792 -11.4043 +2155 4 3.96469 27.2185 26.149 7.10467 -3.13705 18.347 +2156 4 3.97939 27.9962 24.8424 10.8751 21.6711 -8.62461 +2157 6 34.4448 32.9974 30.68 48.2331 9.00339 -1.41906 +2158 4 33.5189 32.8245 30.8394 -9.09046 9.48004 8.12592 +2159 4 34.8804 33.6211 31.3233 -29.3839 -17.782 -5.29467 +2160 6 35.2611 23.7526 9.83248 5.28039 9.63542 14.9856 +2161 4 34.4624 23.9143 9.32096 3.45609 1.41047 -6.97204 +2162 4 35.624 22.9154 9.5528 3.26088 -11.8232 -8.34585 +2163 6 42.4243 15.7233 8.97763 12.8326 1.39623 12.6931 +2164 4 41.658 15.328 8.60072 -22.8346 -8.994 -22.1277 +2165 4 42.104 15.9534 9.85586 1.77226 3.68974 5.84069 +2166 6 7.76866 28.8533 32.9548 -11.0049 17.2013 -15.4709 +2167 4 8.04862 28.1203 33.4848 1.42969 -15.0059 16.0601 +2168 4 8.50079 29.0495 32.3677 8.58058 4.20069 -3.59376 +2169 6 17.6953 41.2515 36.4663 -11.3067 -18.3758 74.5383 +2170 4 16.8889 41.7296 36.6796 -1.19906 6.43806 -6.60961 +2171 4 17.8689 41.3412 35.574 12.2332 11.1792 -57.8962 +2172 6 28.5157 24.2416 15.5518 -29.4686 -13.3801 -11.1317 +2173 4 29.0166 24.9984 15.2559 10.2779 3.66755 -9.57255 +2174 4 28.1226 23.7858 14.7645 18.214 7.11075 11.8426 +2175 6 20.955 16.2999 1.15679 52.4547 14.172 -5.31351 +2176 4 20.9215 15.3848 1.33551 1.21723 -32.5558 11.4722 +2177 4 20.0795 16.5686 1.08505 -57.8144 13.7968 -3.85053 +2178 6 31.1684 40.7359 5.3086 9.60886 -48.7905 -14.3252 +2179 4 30.3201 40.4364 4.96776 -1.1434 5.1051 1.34806 +2180 4 31.1111 41.6485 5.46945 -11.8258 44.905 11.395 +2181 6 29.926 24.7744 36.4585 -3.76808 18.8348 4.26027 +2182 4 30.4252 25.4661 35.9713 -7.21832 -13.6313 5.02454 +2183 4 29.9738 23.9763 35.9568 8.68635 -20.1437 -13.5665 +2184 6 8.66863 31.0429 3.90108 5.49181 -25.3701 -11.391 +2185 4 7.74616 30.7992 3.95988 -7.56137 -0.630176 -1.16432 +2186 4 8.75287 31.8877 4.30735 2.25384 31.6916 10.4967 +2187 6 5.52708 32.7014 11.4113 -17.1068 -29.6258 4.38787 +2188 4 4.72561 33.1583 11.715 12.8879 6.23598 -5.09299 +2189 4 5.16474 31.7796 11.3163 19.6841 23.1791 1.24929 +2190 6 45.6525 35.4522 20.4433 4.50188 -15.2767 -13.8779 +2191 4 45.1533 35.403 19.6071 0.884587 3.9764 11.125 +2192 4 46.1815 34.6145 20.4501 -8.61117 18.3435 2.22997 +2193 6 19.5135 2.78077 9.78076 -23.679 -24.2198 -16.6656 +2194 4 19.3296 3.70289 9.60293 -7.62346 7.89228 3.64078 +2195 4 18.7563 2.26696 9.35595 24.4568 20.2801 14.4664 +2196 6 54.9521 9.08257 10.915 1.41457 -13.8994 3.08946 +2197 4 54.8451 8.89609 11.8656 1.69601 3.75098 -5.72792 +2198 4 0.659909 9.73404 10.7859 1.63405 2.05096 5.26063 +2199 6 21.028 26.5613 14.7909 22.3934 -16.1712 -61.6784 +2200 4 21.2545 26.1082 13.8887 -5.63248 33.4215 43.8962 +2201 4 20.0757 26.5096 14.8457 -4.66041 -4.09977 8.40724 +2202 6 14.1565 30.5187 27.5481 43.0568 3.88252 13.2649 +2203 4 14.5478 30.2647 28.4319 -11.7888 3.54471 -30.6513 +2204 4 14.9443 30.8429 27.0102 -33.9181 -6.53128 14.6047 +2205 6 29.8147 17.3367 31.0866 -27.8518 -4.92818 12.2149 +2206 4 30.6554 17.4646 30.6741 20.9401 8.7355 -10.9161 +2207 4 29.248 18.1063 30.9142 12.1966 -0.59561 3.44929 +2208 6 50.8794 17.2985 27.8251 -38.7154 2.44379 -6.74856 +2209 4 49.927 17.6315 27.8951 41.9068 -8.6615 -2.42711 +2210 4 51.4551 17.8493 28.3603 -3.47276 2.02156 5.1771 +2211 6 46.2645 37.0852 13.9854 4.42941 -15.3994 -45.1385 +2212 4 46.1048 37.4162 14.8449 -7.65894 23.339 32.9902 +2213 4 45.682 37.569 13.3645 -0.578519 -6.08013 10.2779 +2214 6 38.1859 37.2676 33.1408 3.52211 -11.0724 24.5555 +2215 4 38.5393 37.4103 34.0404 -6.68303 -10.0954 -6.88307 +2216 4 38.6219 37.9461 32.6369 2.42637 17.4604 -15.0111 +2217 6 41.8357 13.3473 31.1178 -16.0625 23.8584 17.742 +2218 4 41.5851 13.9423 31.8754 7.82637 -22.3228 -20.2899 +2219 4 42.4009 12.6411 31.4368 6.59024 -10.1979 3.85371 +2220 6 46.9027 12.6459 17.8387 -27.1897 30.7666 -32.0186 +2221 4 46.619 13.5972 17.8049 11.7948 -22.8605 3.48595 +2222 4 46.5208 12.2901 16.9886 18.0608 -3.03081 22.7278 +2223 6 32.0582 10.0955 10.6527 -31.4378 50.3229 23.4622 +2224 4 31.7762 9.76632 11.5317 8.81554 -8.40176 -19.9459 +2225 4 31.6698 11.0464 10.7004 29.7372 -48.0302 -12.3835 +2226 6 34.0062 11.3773 6.75186 17.7871 30.589 25.6979 +2227 4 33.4869 10.5999 6.69262 -19.6684 -30.9606 -3.70709 +2228 4 33.8274 11.7035 7.66069 0.227829 -0.558148 -16.2574 +2229 6 45.3288 30.8634 19.4834 2.25993 -0.395596 -7.26595 +2230 4 45.2654 30.706 20.4282 2.85912 -9.1252 8.63447 +2231 4 45.808 30.1003 19.1195 -1.86475 4.39364 7.74954 +2232 6 20.3535 0.575918 7.15275 2.53913 19.7072 2.1264 +2233 4 20.3036 0.62077 8.11765 -6.02971 -5.31178 -3.74759 +2234 4 20.3373 41.5708 6.90351 -3.42232 -20.4047 0.354773 +2235 6 15.9901 39.4523 4.14302 -22.6863 14.3541 -4.96379 +2236 4 15.4898 39.956 3.48033 13.9059 -6.08345 -3.0001 +2237 4 15.6535 39.8695 4.95456 5.06581 -11.7067 3.21286 +2238 6 52.4222 16.4823 25.1021 7.38571 -14.026 0.748627 +2239 4 51.9391 16.8928 25.8315 -3.23714 5.96419 -6.435 +2240 4 52.4547 17.0876 24.3371 -9.72126 -3.91711 12.1205 +2241 6 38.5305 12.9945 3.24722 36.6577 77.8042 9.91619 +2242 4 38.7269 13.7231 3.96388 -16.2716 -45.5952 -32.5571 +2243 4 38.0745 12.2732 3.61889 -23.0516 -27.5087 18.4748 +2244 6 35.1404 29.6968 31.1683 -32.7778 -10.63 75.6098 +2245 4 35.326 30.1595 30.3922 19.5999 28.8984 -42.5223 +2246 4 34.769 30.3505 31.8393 8.36493 -22.8372 -28.4638 +2247 6 9.52941 33.7628 4.86075 -28.4918 10.8311 18.4951 +2248 4 9.24769 34.3211 5.62607 6.24621 -9.23174 -22.6788 +2249 4 10.3628 33.3905 5.10095 17.2263 -8.07265 -0.549435 +2250 6 21.5384 22.0668 20.5377 -8.24916 -13.7408 18.0665 +2251 4 20.8389 22.6833 20.2982 1.69112 5.82217 1.92954 +2252 4 21.3229 21.7148 21.445 5.44386 11.4228 -26.5573 +2253 6 37.5752 11.1922 41.2961 -25.7405 -15.8592 15.4541 +2254 4 38.0284 11.8044 40.7564 10.4246 30.4728 -30.151 +2255 4 38.2644 10.586 41.5433 15.0535 -11.8566 15.4014 +2256 6 33.8981 1.42806 38.7459 -9.94409 -6.93964 -8.18458 +2257 4 33.592 0.608166 38.3248 2.39341 2.703 9.2739 +2258 4 33.9534 1.28552 39.7002 -3.4763 3.29487 -4.45631 +2259 6 4.57081 26.6822 28.0049 6.08842 -57.033 -35.5124 +2260 4 5.0914 25.8197 28.0746 -15.9746 40.4578 4.78317 +2261 4 4.85783 27.3427 28.6052 16.6445 16.915 24.1865 +2262 6 10.2586 0.903759 11.6235 -14.777 -30.5961 35.2813 +2263 4 10.598 1.12099 12.5147 -1.53351 -1.03605 -18.7158 +2264 4 10.5217 1.55247 11.0069 12.731 34.1315 -22.4253 +2265 6 17.6428 19.8087 2.34625 28.3489 11.7442 10.4095 +2266 4 17.8694 20.4455 1.65312 -0.920106 -2.92675 2.15413 +2267 4 18.5186 19.4679 2.66241 -18.7748 -2.39069 -7.57655 +2268 6 32.4269 25.6656 16.4745 -22.7384 46.4686 12.005 +2269 4 32.9526 26.0936 17.1754 -0.693509 -13.2017 -11.5041 +2270 4 32.8268 24.9018 16.1119 18.5502 -33.1172 -3.66835 +2271 6 33.2526 10.6326 0.323883 9.44704 -29.8166 -9.67306 +2272 4 32.8511 9.97264 41.5994 12.5609 21.6724 15.7642 +2273 4 34.1113 10.2426 0.662313 -26.6835 12.0422 -7.05376 +2274 6 4.94395 4.51414 10.1428 13.8645 5.4827 29.102 +2275 4 4.09398 4.95549 10.181 -4.94694 -3.34603 -2.54834 +2276 4 5.29018 4.56097 11.0773 -8.61071 -3.77852 -28.7481 +2277 6 27.0981 16.9726 9.55361 -31.982 10.5528 -14.2027 +2278 4 27.1645 17.5497 10.32 4.78099 0.707575 6.97209 +2279 4 26.2221 17.2303 9.15822 25.9284 -7.90001 11.4222 +2280 6 9.97547 10.5192 19.3751 2.18725 8.20489 55.882 +2281 4 10.4385 9.92127 18.8097 14.3325 -20.7925 -15.5795 +2282 4 10.1136 10.195 20.3283 -2.00877 10.2565 -41.5362 +2283 6 19.5726 8.5313 27.8509 32.1681 -5.32712 19.6321 +2284 4 20.0623 8.73326 28.6965 -13.9453 -3.32017 -28.6613 +2285 4 20.1531 7.88958 27.3718 -16.7413 15.1406 10.2365 +2286 6 47.0715 38.9553 23.1297 -19.9487 1.16408 5.20576 +2287 4 47.6755 38.9992 22.3956 6.55525 -5.77104 -8.99339 +2288 4 46.1921 38.7934 22.7438 5.29072 4.97192 1.21114 +2289 6 19.6864 25.3648 11.2698 -35.9279 -4.62509 3.50742 +2290 4 18.9891 24.6498 11.3772 26.0807 25.4649 -7.71219 +2291 4 19.2193 26.1995 11.535 7.74761 -20.7647 -6.77192 +2292 6 27.3916 13.4622 15.7395 34.9583 -25.2468 -27.4167 +2293 4 26.6227 13.8144 16.1317 -23.8298 14.7279 29.1585 +2294 4 28.0863 13.1847 16.3728 -7.05347 8.15442 -0.924368 +2295 6 18.6718 14.1326 1.43279 -0.407031 -28.5308 -28.57 +2296 4 18.3771 15.0354 1.29678 -0.169849 11.7565 -8.38297 +2297 4 19.1904 13.8513 0.615983 -22.2167 19.1803 27.2908 +2298 6 42.3082 22.0346 32.4819 -45.1257 5.10199 -13.868 +2299 4 42.1064 21.5657 33.301 1.02444 -1.81924 7.74271 +2300 4 41.4227 22.4584 32.2639 35.231 -14.359 4.36271 +2301 6 10.0299 9.44853 2.50633 35.8335 -20.1603 -5.5533 +2302 4 9.22808 9.80314 2.87263 -22.9312 8.40439 12.9687 +2303 4 10.3707 8.71125 3.07205 -18.436 14.324 -8.13067 +2304 6 6.82989 1.45163 22.0085 -48.1074 -31.7833 -34.6048 +2305 4 5.93364 1.52189 21.5813 27.761 13.2569 19.2226 +2306 4 6.99793 0.508973 21.801 12.0554 14.7409 9.93393 +2307 6 11.2802 27.0298 18.9733 1.62982 48.8223 -5.8971 +2308 4 11.8533 27.1031 19.7597 -5.53045 -6.49976 -4.21856 +2309 4 11.2066 27.9871 18.6476 2.337 -33.8373 14.078 +2310 6 41.4807 20.5084 27.2133 -10.1157 30.3313 5.28758 +2311 4 41.6238 21.1535 27.9303 0.1153 -0.646751 -15.7402 +2312 4 41.3475 19.7242 27.7174 2.20222 -28.2193 4.24429 +2313 6 15.4457 24.115 33.4309 -8.0908 -15.9975 4.96928 +2314 4 14.6694 24.1264 34.0087 5.2648 16.329 -3.20307 +2315 4 15.6051 23.1634 33.3621 10.6851 2.75783 3.25666 +2316 6 36.1374 16.3773 10.0083 -2.95201 1.72364 21.0093 +2317 4 36.0354 15.4723 9.6971 0.275369 -1.57281 -6.84486 +2318 4 36.1532 16.3058 10.9756 2.3103 1.89663 -9.38056 +2319 6 51.7249 16.2592 2.09899 -0.8354 -35.479 4.00209 +2320 4 51.3025 16.6477 2.84061 -15.4293 29.383 24.1936 +2321 4 51.7588 15.3279 2.40044 5.70816 13.7616 -13.313 +2322 6 23.409 8.55726 39.7719 39.5062 -11.15 -25.6965 +2323 4 23.7264 8.82822 38.8637 -18.295 -2.70527 32.3134 +2324 4 24.154 8.00621 40.1033 -17.8621 14.2471 -2.43096 +2325 6 36.7611 34.4487 21.1056 -9.59584 -7.71653 -9.58874 +2326 4 37.1943 34.5847 20.2534 -2.45984 1.11901 0.357954 +2327 4 35.8017 34.351 20.9183 13.0848 5.20904 4.89404 +2328 6 14.146 8.88688 27.2949 11.3522 43.6232 -16.453 +2329 4 13.5534 8.17113 27.3093 -27.716 -37.4722 8.68734 +2330 4 15.0033 8.5993 27.5988 11.0136 -4.6565 4.44913 +2331 6 20.6652 37.4903 25.1946 -10.211 -17.9881 -36.0994 +2332 4 20.7454 36.6557 24.6643 4.11278 14.2078 23.4923 +2333 4 20.5382 38.1243 24.4693 3.50396 4.35638 18.4557 +2334 6 28.825 24.4792 30.0383 -7.87557 -12.5525 -14.3175 +2335 4 28.2203 24.3409 29.2957 -5.62902 14.2643 8.72595 +2336 4 29.6177 24.0933 29.6588 14.1928 -3.34691 9.72359 +2337 6 8.38024 12.0023 23.6849 17.6034 -17.8042 43.8798 +2338 4 9.33151 12.0391 24.0095 -25.5352 0.9508 -22.7134 +2339 4 7.93543 11.4413 24.3789 8.15752 13.9726 -18.9857 +2340 6 16.0957 26.6613 22.9482 -4.23776 -4.88874 3.00129 +2341 4 16.4041 25.8866 22.4682 2.11349 3.20317 -0.347462 +2342 4 15.2797 26.4088 23.4009 6.04671 4.79823 1.078 +2343 6 22.346 41.3881 9.48723 24.9275 -16.664 -2.62618 +2344 4 22.5706 0.299269 9.06271 5.87112 18.1013 -4.15908 +2345 4 21.5005 41.5154 9.87839 -30.5435 3.49176 4.55444 +2346 6 49.3776 19.1851 32.3736 41.1751 -38.6142 12.6649 +2347 4 49.9515 18.5305 32.8666 -19.8114 22.1793 -24.5398 +2348 4 48.9751 19.6643 33.0815 -18.7203 16.5505 12.5326 +2349 6 29.672 28.434 31.2292 -0.0990093 -59.7528 33.1636 +2350 4 30.5672 28.114 31.0525 8.33151 24.242 -15.2883 +2351 4 29.4026 27.6233 31.7702 -3.76231 36.9508 -17.5145 +2352 6 5.09757 39.1181 23.5694 28.9365 -16.8561 66.257 +2353 4 5.426 38.785 24.4883 -20.96 9.44698 -53.4069 +2354 4 5.17377 40.064 23.6953 -4.19226 13.7611 -6.16678 +2355 6 42.9396 13.594 41.6013 33.1291 -45.1938 12.1175 +2356 4 42.8466 14.3322 41.0449 -16.6361 37.6348 -21.2948 +2357 4 42.1546 13.3797 0.17078 -22.3633 5.8076 7.08965 +2358 6 21.2201 12.4318 7.37385 41.5974 -14.6934 -10.3279 +2359 4 20.2896 12.3563 7.35505 -36.2241 5.92132 -7.85999 +2360 4 21.5284 11.6004 6.96932 1.7608 11.2928 4.8084 +2361 6 43.1404 26.8989 37.6922 38.0431 -66.5876 34.8581 +2362 4 42.455 26.3454 37.3085 -15.3628 11.0452 -11.3741 +2363 4 43.7284 26.1839 38.1775 -25.099 52.0029 -25.4853 +2364 6 19.5406 10.6485 41.687 -7.00401 -34.9019 -10.1363 +2365 4 19.0738 10.6767 0.596923 -7.19888 -1.38148 21.2635 +2366 4 19.8536 11.5162 41.559 12.2515 43.5875 -9.13673 +2367 6 53.6223 10.061 3.2559 12.5469 7.56169 -12.6981 +2368 4 54.2024 10.8465 3.22155 -5.5124 -7.95383 7.8004 +2369 4 54.0687 9.40413 2.68363 -10.8512 12.6529 5.34221 +2370 6 17.5742 20.1926 28.4231 -27.2496 23.4973 23.4861 +2371 4 18.0413 19.6307 27.8376 17.787 -14.8025 -21.0857 +2372 4 18.1273 20.2938 29.2048 3.54631 -0.489564 0.0042962 +2373 6 36.884 7.32584 1.68504 -56.6071 21.2656 -14.3658 +2374 4 37.7051 7.59774 2.01592 38.2946 9.18211 20.2394 +2375 4 36.4748 8.1931 1.44071 3.42518 -20.8507 2.42249 +2376 6 29.2181 41.4159 1.83346 -7.01124 13.363 14.2223 +2377 4 28.4272 0.01466 2.15652 15.3791 -9.50345 -13.4545 +2378 4 29.1899 41.2946 0.880744 -4.61983 7.49126 -6.31737 +2379 6 13.5157 3.09172 8.12958 -12.3356 7.91728 -16.4605 +2380 4 12.824 3.78046 8.01164 12.4629 -9.10221 7.3254 +2381 4 13.8551 3.1491 9.02604 -1.1531 -1.24526 3.73064 +2382 6 15.0243 29.578 18.5071 -0.689822 5.1468 -1.91807 +2383 4 14.6889 28.924 17.8685 -1.8514 4.35612 11.642 +2384 4 14.2858 30.1508 18.7969 8.46412 -5.78667 -10.3485 +2385 6 10.5031 24.7013 24.3729 39.9308 52.3958 -21.489 +2386 4 10.8696 24.6855 23.439 -22.6214 -1.85919 30.3756 +2387 4 10.1444 23.8694 24.566 -23.1097 -44.7323 0.689524 +2388 6 2.33043 13.8499 25.1512 12.2217 -8.49201 10.1592 +2389 4 1.51988 13.5482 24.7402 -5.80441 -9.83551 -11.7005 +2390 4 2.2572 14.7938 25.1495 -10.3249 16.8303 -2.61333 +2391 6 31.8608 32.7615 29.8175 -5.917 1.92483 -13.0568 +2392 4 30.9148 32.9142 29.9093 1.86919 3.45723 4.06263 +2393 4 31.9038 31.8703 29.4643 1.33296 -6.10517 -4.90202 +2394 6 37.5413 40.8309 33.9785 -53.8639 -49.1526 -10.38 +2395 4 37.2515 40.0243 34.5353 23.0474 40.5808 -8.35317 +2396 4 36.818 40.8104 33.2846 24.4839 11.2763 19.2644 +2397 6 24.0486 38.1463 34.3459 4.38709 -25.8386 -29.9356 +2398 4 24.1932 38.0251 35.2675 1.20986 12.6476 31.9448 +2399 4 24.4562 37.3431 33.9843 -4.45208 9.66559 -5.62065 +2400 6 37.1813 22.5726 7.37313 12.7367 -26.0408 21.8779 +2401 4 37.6868 21.7363 7.50199 -14.9443 17.386 1.08188 +2402 4 37.2974 22.7741 6.46124 2.1827 3.60906 -24.8808 +2403 6 4.31908 23.2435 35.594 -25.7168 -2.52913 6.61784 +2404 4 4.31865 22.3787 35.1609 -1.33991 4.89576 -0.266123 +2405 4 3.37757 23.4898 35.7698 13.7393 -2.9658 -3.46645 +2406 6 15.7444 14.893 2.66063 14.3192 36.2435 46.5189 +2407 4 15.9445 15.8567 2.71494 4.00237 -25.0016 7.78932 +2408 4 15.3014 14.8369 1.84861 -12.1852 -13.1154 -36.1328 +2409 6 48.1607 23.1823 2.03014 17.998 -4.54201 -11.9107 +2410 4 48.5744 23.458 2.84259 8.43731 2.94545 12.5813 +2411 4 48.9225 22.9045 1.46682 -22.9697 5.41467 1.46601 +2412 6 24.1212 19.9771 21.5555 -13.5297 -6.85262 15.9953 +2413 4 24.2241 19.3198 22.2577 -12.7792 13.8262 1.69378 +2414 4 24.7627 19.6352 20.9706 23.452 2.79195 -33.2435 +2415 6 10.5793 29.3754 5.15175 -1.75103 26.9922 -14.4666 +2416 4 9.93004 29.8841 4.64694 -13.9608 -12.0643 5.47156 +2417 4 11.3599 29.8389 4.86113 16.4531 -5.21099 6.28998 +2418 6 5.96767 27.6933 31.2336 10.2296 -18.0279 -26.5205 +2419 4 6.63185 27.1353 30.7398 -17.0624 11.0978 13.8341 +2420 4 6.49058 28.2721 31.7915 6.44996 0.578865 12.7715 +2421 6 18.5397 25.8071 15.3312 30.8629 -17.2743 -78.9847 +2422 4 18.3277 25.7099 16.2038 -28.7942 6.39581 79.7195 +2423 4 17.897 26.3418 14.8644 -17.4943 11.9017 11.8989 +2424 6 52.0949 37.2335 11.1138 -0.736115 -25.1617 0.200807 +2425 4 52.5552 36.4743 10.7101 2.49656 11.0988 9.7325 +2426 4 52.7586 37.8745 11.3958 -2.29245 7.10647 -7.85035 +2427 6 46.8562 14.6296 7.3094 -39.0502 -6.9365 63.794 +2428 4 46.1382 15.0906 7.8718 34.2719 -4.68193 -40.7336 +2429 4 47.0431 13.9061 7.9424 14.2062 7.46383 -20.3992 +2430 6 22.2508 0.698906 41.6783 16.129 -5.34947 -25.8041 +2431 4 22.2008 1.66415 41.7125 4.72421 -6.65403 -6.59212 +2432 4 22.9559 0.389699 41.0229 -20.0941 20.4891 31.5318 +2433 6 4.05761 14.7345 9.27152 -10.7438 13.6286 -6.0443 +2434 4 3.56043 15.5915 9.15395 12.8436 -23.8424 -1.56379 +2435 4 4.93811 14.8828 8.92118 3.87558 5.66633 -1.10852 +2436 6 37.2917 12.6666 37.0157 -30.741 -16.0859 47.3668 +2437 4 37.7371 12.676 37.8973 0.89189 9.6387 -16.8975 +2438 4 36.3707 12.3712 37.2872 32.4569 8.65188 -22.8431 +2439 6 26.6682 29.0903 40.5985 -18.9168 16.4285 3.4146 +2440 4 27.032 28.2632 40.812 19.8197 -36.7417 16.2821 +2441 4 26.6469 29.0593 39.6552 2.37875 14.8387 -20.8034 +2442 6 7.22455 13.851 3.31845 32.6668 -55.3021 -17.7697 +2443 4 8.0198 14.2759 3.60088 8.05656 35.1068 9.02454 +2444 4 7.66854 12.9807 3.04146 -45.3946 28.1811 11.8363 +2445 6 8.95271 34.8627 28.8342 33.802 -52.1542 -15.9648 +2446 4 9.89817 35.0055 28.6074 -18.5208 0.484683 7.95646 +2447 4 8.56267 35.6958 28.9173 -17.8026 46.8286 13.0667 +2448 6 37.1756 40.0691 40.1061 46.0034 7.56439 6.60252 +2449 4 36.245 40.1688 40.0074 -20.2243 -4.13511 -1.70673 +2450 4 37.2907 39.5142 40.8911 -6.64471 -1.97244 -3.69085 +2451 6 30.3689 6.165 27.2364 16.9392 12.8422 63.3115 +2452 4 30.1126 5.75506 28.1249 0.00544273 9.78172 -37.0876 +2453 4 31.0397 6.83064 27.5702 -18.6179 -11.6186 -23.6342 +2454 6 10.4791 22.885 18.2972 2.22892 -25.7937 -34.5052 +2455 4 11.3494 23.0331 18.653 10.7715 4.73748 7.10061 +2456 4 10.6446 22.3032 17.5049 -10.188 21.0769 23.5682 +2457 6 35.8886 14.2524 40.1239 38.6938 29.9036 -1.43051 +2458 4 35.4161 14.6576 39.3846 -1.71718 -13.5804 13.4977 +2459 4 35.4021 13.6019 40.5864 -31.0402 -18.1501 6.5583 +2460 6 6.71723 1.08854 17.7001 -3.83901 -60.8198 25.71 +2461 4 6.23156 1.19942 18.5167 -3.21909 18.7445 0.671973 +2462 4 6.88149 0.099135 17.7878 0.895752 34.2898 -15.7018 +2463 6 41.3468 34.0461 33.1794 10.5682 19.0983 -18.7578 +2464 4 40.4721 34.2712 32.8864 -29.2649 -1.70533 3.43004 +2465 4 41.8357 34.5632 32.5195 11.425 -3.18121 9.05585 +2466 6 37.2595 0.990816 41.287 9.45411 17.3584 -9.40071 +2467 4 37.687 0.20533 40.9743 -1.4253 -22.058 -8.3634 +2468 4 37.4586 1.01742 0.30817 4.28067 1.92511 18.4856 +2469 6 25.2602 30.9527 6.20609 -41.9214 10.7977 -12.9978 +2470 4 25.877 31.4326 5.6764 28.9604 0.775163 -4.96937 +2471 4 24.4759 30.9469 5.60333 12.4846 -9.23957 25.2824 +2472 6 14.2056 24.502 28.3086 -25.5247 14.5131 -24.5719 +2473 4 14.1882 23.6623 28.7056 13.4522 -31.4953 30.087 +2474 4 13.7133 24.2842 27.5041 7.94148 19.2098 -3.82225 +2475 6 34.2051 26.2238 36.0112 -48.9031 41.3361 24.9979 +2476 4 35.1144 26.3624 36.1822 32.7561 -2.50775 4.45543 +2477 4 33.7446 26.9807 36.5344 19.2218 -36.9328 -23.3608 +2478 6 32.3568 8.33098 28 25.7802 40.2385 3.20277 +2479 4 32.7565 9.24505 28.063 -37.9579 -17.4528 3.85033 +2480 4 33.1461 7.94224 27.6538 8.5967 -27.8742 -9.28785 +2481 6 11.7867 0.286536 26.9724 -1.3913 -35.2382 4.72224 +2482 4 11.7865 41.2385 26.6946 0.846362 23.7064 4.93964 +2483 4 11.6054 0.272418 27.9282 2.03777 4.09428 -12.4872 +2484 6 1.68124 0.254113 10.3309 8.7986 -13.2184 -15.0921 +2485 4 1.59717 41.2916 10.7333 -0.0350141 -2.89412 -0.990995 +2486 4 1.41389 0.849687 11.0071 -7.7361 15.4014 20.6266 +2487 6 6.75173 13.8377 8.23874 -3.6693 30.6435 -30.4665 +2488 4 6.43924 13.9799 7.29904 9.51956 -14.6006 30.1073 +2489 4 7.1653 14.6974 8.43116 5.95594 -9.45057 4.81521 +2490 6 22.2348 20.5564 6.16471 -24.0844 -9.72934 13.195 +2491 4 21.6727 21.3518 6.25881 9.87637 -7.56006 0.262552 +2492 4 21.7029 19.8181 6.55593 11.5262 14.9976 -6.6436 +2493 6 17.385 20.4497 10.8769 -35.9329 27.9153 -37.8305 +2494 4 16.5515 20.156 10.4074 25.3596 -4.97581 21.0147 +2495 4 17.441 21.3848 10.5386 11.6957 -25.2138 21.3318 +2496 6 17.7006 4.52737 19.573 -11.3777 -34.9061 -6.08889 +2497 4 17.032 4.43128 20.2569 -5.49224 11.1956 3.68583 +2498 4 17.4813 3.72403 19.0236 15.4315 33.5846 4.92098 +2499 6 0.483339 18.1114 40.0861 11.4726 -7.5634 -25.4826 +2500 4 0.218803 18.6551 40.8031 -6.40406 19.3 17.6992 +2501 4 1.29471 18.4968 39.6981 -7.50073 -9.94226 4.45973 +2502 6 22.9439 24.8131 27.8304 -1.07592 37.7895 -56.3844 +2503 4 22.8309 25.5845 27.1671 -0.125595 -37.7338 24.1587 +2504 4 22.7938 25.2149 28.6606 -3.1997 14.6603 34.334 +2505 6 42.7926 39.1547 26.7662 4.75434 20.2168 6.00074 +2506 4 43.0175 38.5002 26.1242 -2.01943 -24.6309 -11.9253 +2507 4 43.3024 39.9142 26.4608 -1.73796 0.515913 11.2644 +2508 6 26.2338 3.05974 21.8008 -0.713756 21.3652 -6.58596 +2509 4 25.6341 3.75271 22.1513 17.432 -13.3686 -8.49125 +2510 4 26.841 3.50549 21.1637 -15.4189 -7.95734 10.2455 +2511 6 54.5913 9.88629 29.5891 14.6194 -0.200122 15.6168 +2512 4 54.0185 9.11016 29.6389 -2.18077 1.53735 0.0476299 +2513 4 54.8498 10.0557 30.5251 -12.748 -2.88746 -21.9109 +2514 6 24.7662 33.7505 20.5324 -4.4887 -11.5901 7.32024 +2515 4 24.6764 34.6709 20.8407 -1.82029 -5.26135 -2.53883 +2516 4 23.9322 33.4503 20.1388 -0.463927 12.2923 -3.35723 +2517 6 41.7034 16.3049 0.90063 -4.83399 22.4927 -47.1255 +2518 4 41.2734 15.9533 1.64089 -16.394 -13.425 40.883 +2519 4 42.6233 16.3659 1.12415 18.2298 -9.67465 4.77205 +2520 6 23.3998 27.9207 27.4832 -10.7606 37.0497 -28.3533 +2521 4 22.8282 28.3407 28.1441 5.00816 -9.79407 0.156118 +2522 4 23.2556 28.495 26.6632 8.58882 -24.5485 28.392 +2523 6 32.7859 37.2984 18.7364 25.7014 -40.2058 6.96479 +2524 4 33.7401 36.9719 18.7703 -32.5146 22.7172 4.70252 +2525 4 32.7784 38.1932 18.4283 6.4981 19.1078 -10.0488 +2526 6 21.2249 27.6889 4.78917 1.7584 -25.2435 -20.8654 +2527 4 20.596 27.4146 5.46499 -5.42949 1.48454 -4.75098 +2528 4 21.0369 27.1287 3.96943 -0.427807 22.4392 26.4825 +2529 6 54.9457 17.9605 1.83049 24.1732 12.1415 15.992 +2530 4 54.6765 17.1472 1.44643 -11.2843 -21.2768 -12.0273 +2531 4 54.1938 18.5428 1.86671 -18.1074 1.0363 -7.50679 +2532 6 36.7435 10.702 6.59289 -49.1612 2.30359 2.88264 +2533 4 35.7736 10.9925 6.66913 36.3355 -9.83622 -8.29906 +2534 4 36.7226 9.77144 6.87602 6.19961 4.27664 0.325158 +2535 6 54.2959 4.49421 14.021 -47.0247 26.1641 -8.2037 +2536 4 53.712 4.99768 13.3924 28.2438 -8.88077 8.93165 +2537 4 53.834 4.66365 14.8572 10.6634 -9.95324 4.36694 +2538 6 22.1071 12.8195 32.0067 31.7906 8.9597 -11.0311 +2539 4 21.2967 13.3066 31.9589 -27.922 0.108445 -0.906739 +2540 4 22.6887 13.2954 31.3728 -6.4895 -15.5456 16.1837 +2541 6 15.3021 36.6565 4.03444 -21.8215 23.8176 13.2077 +2542 4 15.3262 37.6185 3.88215 -1.10116 -7.72226 9.53853 +2543 4 16.0423 36.3695 3.52653 17.7184 -15.2462 -10.6327 +2544 6 23.951 1.27123 5.71091 12.3119 19.4094 13.4558 +2545 4 23.1735 0.716989 5.76524 -11.3354 -5.61231 -0.786433 +2546 4 24.0519 1.77027 6.55293 -6.00641 -12.6326 -15.7345 +2547 6 14.2792 12.648 15.8066 19.0644 9.13243 11.8341 +2548 4 14.5911 12.5731 14.893 -12.6174 -10.6299 -3.28453 +2549 4 13.3818 12.3002 15.9605 12.2346 2.97194 -15.7557 +2550 6 15.0388 40.2481 6.5891 -30.9219 -16.0267 -20.9978 +2551 4 15.8926 40.3583 6.97574 17.8619 16.6743 19.574 +2552 4 14.4622 41.0349 6.73493 18.0926 -11.8876 3.06612 +2553 6 48.5605 32.6308 12.0872 21.4935 -15.1737 -19.6402 +2554 4 48.2882 31.8163 11.6222 -11.7375 10.5522 8.8403 +2555 4 49.3772 32.8772 11.5869 -20.063 0.749688 13.0696 +2556 6 11.2909 31.5377 7.21713 -14.6129 -9.26005 -15.8818 +2557 4 10.6224 30.9548 6.78826 17.7824 9.96971 10.6082 +2558 4 11.6163 32.1134 6.50388 0.884245 -9.77636 6.63484 +2559 6 30.1231 27.9968 10.2226 9.10006 8.28679 -14.6513 +2560 4 30.718 28.7273 9.95045 -8.34799 -9.59518 10.9295 +2561 4 29.9727 27.4897 9.40845 -5.6962 -0.318113 1.27302 +2562 6 27.6759 22.1164 17.3809 2.93811 -8.1883 -22.8269 +2563 4 27.2909 21.5233 16.7142 1.55949 -2.9899 10.1125 +2564 4 28.0309 22.8242 16.8263 2.77593 4.45495 11.6125 +2565 6 12.9654 4.59514 18.1625 -0.934721 -11.3223 -0.518608 +2566 4 13.4589 3.798 18.4727 -12.2499 12.1104 -13.3514 +2567 4 12.4628 4.36939 17.3497 12.7979 1.84773 4.27522 +2568 6 19.7203 6.71654 19.0744 25.855 21.5282 16.2244 +2569 4 18.977 6.16103 19.2554 -18.9537 -21.446 -0.739234 +2570 4 20.1996 6.78409 19.9214 -9.72031 -0.922856 -11.6068 +2571 6 37.1527 31.3787 11.4669 20.5156 -3.08539 55.9419 +2572 4 36.5467 31.6235 12.1801 -19.4555 -0.126446 -17.2692 +2573 4 37.8531 31.0173 12.0578 -6.7166 -8.42047 -30.0342 +2574 6 3.11862 16.2015 27.3491 -14.8948 -19.7352 -9.46107 +2575 4 2.52427 15.4561 27.6487 20.3886 21.5408 -12.2486 +2576 4 3.15348 16.212 26.3649 -6.24389 -0.0501167 23.7097 +2577 6 15.7133 9.97724 38.3591 30.328 17.4212 13.8857 +2578 4 16.1258 10.8398 38.0549 -11.3336 -30.4403 16.2583 +2579 4 16.257 9.66317 39.1359 -16.0932 10.0631 -23.9552 +2580 6 13.4043 14.2884 8.2363 15.0986 25.1191 -5.83206 +2581 4 13.804 15.2225 8.33958 -5.13839 -47.7054 6.28407 +2582 4 14.0947 13.5837 8.31616 -11.6402 16.8216 1.41307 +2583 6 1.71524 24.3141 36.392 36.4901 -22.2748 31.9402 +2584 4 1.86474 25.1068 36.8985 9.35176 9.25273 5.49175 +2585 4 1.1215 24.6177 35.7571 -36.8309 10.6894 -41.0698 +2586 6 11.1862 26.5319 32.9688 15.239 -24.9993 36.2438 +2587 4 10.9649 26.8002 32.096 -11.5382 16.0703 -24.8314 +2588 4 11.1647 27.266 33.6054 -7.17864 1.89937 -11.754 +2589 6 29.5773 0.765668 36.2911 32.6527 8.9619 33.1448 +2590 4 29.1495 0.596705 35.4758 -23.483 -6.97315 -25.4485 +2591 4 28.9625 1.07408 36.9696 -5.35236 0.153158 -12.2969 +2592 6 43.6099 13.1071 23.908 -7.75428 16.7256 -33.2383 +2593 4 42.8302 13.3868 24.3919 -4.08537 -1.1131 9.93358 +2594 4 43.3622 13.2586 22.9511 7.4693 -9.27191 32.0602 +2595 6 7.44309 19.7767 19.6705 17.8438 12.6527 -6.23579 +2596 4 6.73015 19.1919 19.919 -3.61392 -10.9972 -0.189724 +2597 4 7.6227 19.7194 18.722 -11.1837 -0.704544 3.42764 +2598 6 24.4259 4.29913 7.83629 -8.5248 -0.10499 -3.36953 +2599 4 24.144 5.21077 7.98541 -0.150025 -7.47068 -3.31634 +2600 4 24.9904 4.0546 8.57206 4.90899 -0.271036 -1.18338 +2601 6 51.4883 30.2308 31.1674 -14.7545 1.56633 -0.747328 +2602 4 50.5925 29.8847 31.2768 -1.35209 3.55691 8.49804 +2603 4 51.5844 30.2463 30.2146 11.2248 2.3182 -11.9335 +2604 6 0.913373 23.6795 16.8764 44.9279 -35.4578 23.1065 +2605 4 0.053834 23.3329 16.7065 -24.7033 4.18361 -15.1926 +2606 4 1.39802 22.8443 17.1197 -4.68332 28.5423 -3.90241 +2607 6 45.0884 19.3939 15.6913 9.05154 29.148 -44.7311 +2608 4 45.9115 18.9543 15.4906 10.1171 -6.0821 0.331933 +2609 4 44.8041 18.9926 16.4702 -27.3917 -26.115 43.7395 +2610 6 17.5003 8.70625 40.5861 -20.5343 49.5779 -9.15489 +2611 4 18.1762 9.35755 40.8219 0.532033 0.318295 -4.52849 +2612 4 17.8864 7.89597 40.8225 20.4785 -39.0634 11.6529 +2613 6 30.1832 27.259 27.1983 -17.9859 30.5387 -1.70378 +2614 4 31.0843 27.5469 27.0174 5.19664 -5.65516 3.8328 +2615 4 29.6652 28.1124 27.2385 17.8651 -30.9588 0.0373123 +2616 6 43.0672 26.1987 28.3737 -1.21405 11.7795 -35.2128 +2617 4 43.2187 25.7399 27.5308 2.18298 5.51683 1.33219 +2618 4 43.1307 25.5038 29.0079 -1.74848 -11.3154 21.2466 +2619 6 27.987 7.5851 3.0601 9.13665 18.2748 23.7588 +2620 4 28.1896 6.93215 2.40721 -2.30749 -24.2619 -13.6918 +2621 4 28.5512 7.39371 3.84357 -9.52219 0.418204 -9.11945 +2622 6 44.6779 7.22362 10.1855 -3.82519 12.3682 29.7072 +2623 4 44.5846 7.37997 11.1613 -8.64186 4.71212 -23.3906 +2624 4 45.2067 6.43644 10.1815 9.68596 -14.557 -3.94398 +2625 6 23.537 20.3907 32.2607 -4.33975 0.880185 -5.57314 +2626 4 23.324 21.1985 32.7413 -3.519 5.94106 -1.71472 +2627 4 23.9311 19.8373 32.9365 5.99895 -7.24541 1.02787 +2628 6 37.5412 21.0533 29.2807 6.26587 16.0676 16.0196 +2629 4 37.3761 20.3248 28.6837 -16.0493 -11.7352 -10.5522 +2630 4 36.7218 21.4261 29.6708 7.43039 -8.09007 -9.52559 +2631 6 49.2859 29.0787 28.7031 8.16517 -18.5587 -1.11584 +2632 4 48.658 29.8007 28.598 1.09858 8.52384 -10.5349 +2633 4 50.1522 29.3365 28.3345 -7.12297 8.09394 6.40204 +2634 6 47.5144 18.1684 15.2382 -13.098 45.3115 -50.4885 +2635 4 48.063 17.6794 15.7982 26.613 -22.2712 34.0874 +2636 4 48.011 18.9832 14.9644 -13.0138 -21.3801 10.9042 +2637 6 23.2587 11.168 16.5961 -34.2623 -16.0228 11.9175 +2638 4 23.8181 11.8474 16.2701 22.3391 18.1069 -12.9732 +2639 4 23.6107 10.3074 16.3447 5.63526 2.71733 -4.05723 +2640 6 3.14661 8.32736 23.1966 -5.33081 14.6732 5.33529 +2641 4 3.33443 7.84562 22.3891 5.23826 -4.81966 -4.36628 +2642 4 3.62138 9.17513 23.1245 -2.82501 -4.35917 1.75332 +2643 6 0.508878 16.1819 6.17622 16.4304 7.97407 55.7173 +2644 4 1.47866 16.3831 6.12713 -25.5039 -9.61354 -6.44341 +2645 4 0.329178 16.1408 7.1857 2.48639 -0.0834422 -46.7437 +2646 6 43.1796 15.6993 5.84098 -15.9449 -20.1226 -10.4934 +2647 4 42.9586 16.4507 6.36104 0.864404 19.5468 17.3894 +2648 4 44.0486 15.8407 5.47017 17.9332 8.6581 -2.45416 +2649 6 16.7038 35.4743 34.4518 -23.198 12.4372 32.502 +2650 4 15.9504 35.0582 34.0028 7.47206 -3.63127 2.95791 +2651 4 16.3197 35.7905 35.3305 20.1374 -9.24319 -26.2799 +2652 6 38.8854 7.73874 15.6833 27.6202 35.8952 13.402 +2653 4 39.2486 7.07212 15.1014 0.737034 -8.76325 -8.48971 +2654 4 39.6641 8.33099 15.9666 -32.1226 -27.7665 -11.1551 +2655 6 42.0076 36.5182 13.641 -8.45099 16.164 -4.64077 +2656 4 41.9228 35.5752 13.5656 2.538 -16.9665 4.44933 +2657 4 41.1544 36.8356 13.3036 3.7559 4.14555 2.82714 +2658 6 54.2986 15.3848 32.1119 10.5246 -16.1102 10.831 +2659 4 0.035655 15.9755 32.3754 -8.42237 -3.15332 1.00609 +2660 4 53.5781 15.9253 31.7943 -3.3302 7.96061 -4.64421 +2661 6 22.8954 13.9973 39.0304 35.7671 -1.21675 7.49641 +2662 4 23.2761 14.8055 39.421 -4.93619 -7.73369 -6.00904 +2663 4 21.9819 14.1606 38.8837 -32.0989 6.28079 -4.51925 +2664 6 48.0426 28.53 4.78367 -18.7604 -12.0579 33.007 +2665 4 48.5209 28.7824 4.01456 21.1512 11.8238 -22.7946 +2666 4 47.6247 29.3288 5.14776 5.26678 3.3179 -1.38234 +2667 6 48.833 10.6059 2.66638 -9.19187 -9.9608 -41.9733 +2668 4 48.2371 10.184 3.25557 -19.2293 -15.3999 15.8868 +2669 4 49.4018 11.1117 3.19515 27.1663 25.8201 26.2609 +2670 6 17.1043 29.3494 4.41938 0.116954 -3.05469 4.91749 +2671 4 16.3442 28.823 4.73493 -1.75912 12.177 1.49975 +2672 4 17.4207 29.929 5.14153 -0.429925 -17.6765 -0.899977 +2673 6 27.7901 7.33424 26.577 58.6208 -10.7281 -9.65958 +2674 4 28.6921 6.89516 26.6033 -20.1634 35.8081 4.28732 +2675 4 27.2961 6.54785 26.6418 -36.3357 -24.7905 3.70209 +2676 6 18.0242 22.0537 22.5144 -27.9591 -16.1551 -40.0832 +2677 4 18.4878 21.2118 22.5153 10.7066 -2.42354 6.7168 +2678 4 17.4966 21.98 21.6478 21.0889 16.8172 36.9195 +2679 6 22.144 25.0979 16.6837 -22.767 31.6961 -6.75713 +2680 4 21.8754 25.6012 15.8609 3.46788 -12.1894 37.0641 +2681 4 22.4796 24.2953 16.3382 13.1119 -24.3628 -7.92486 +2682 6 25.5147 28.4379 7.13209 -32.2353 18.5879 42.0502 +2683 4 25.3191 28.6153 8.09624 16.8162 -18.2828 -29.7283 +2684 4 25.4949 29.3399 6.82105 5.5127 9.28731 -21.7507 +2685 6 42.5447 24.7469 23.7482 -26.0567 17.8354 -0.260974 +2686 4 41.659 25.0561 24.0862 27.8337 1.55541 -7.56443 +2687 4 42.5141 23.8045 23.8516 -5.7883 -22.6777 0.706816 +2688 6 6.24511 16.6188 2.47068 -21.6781 9.7655 5.77715 +2689 4 5.36273 16.9874 2.41541 -6.24724 13.8235 -1.18511 +2690 4 6.01398 15.7093 2.58331 16.9883 -26.009 1.35247 +2691 6 47.3719 33.28 1.46148 -3.99946 1.01934 -28.2481 +2692 4 46.9803 34.1218 1.66358 -4.59906 12.9067 -8.65937 +2693 4 47.69 33.0389 2.30921 14.6803 -12.3184 23.7614 +2694 6 1.27616 36.1851 24.8829 8.16993 1.58395 -5.27854 +2695 4 0.639753 36.4584 25.5359 -13.8461 11.829 3.50901 +2696 4 1.57271 35.3754 25.2942 10.46 -9.74103 -2.86729 +2697 6 20.9413 29.0442 16.4303 -37.0385 3.95749 11.2157 +2698 4 21.4069 28.5201 15.8013 19.747 -14.8546 -14.4583 +2699 4 21.4101 29.8248 16.6953 16.4704 9.62387 -0.234111 +2700 6 18.6701 32.5426 14.1399 -11.935 -28.2137 10.094 +2701 4 17.8036 32.9051 14.2078 -15.3524 29.2867 2.90472 +2702 4 18.4356 31.618 14.3552 23.1856 4.50503 -1.59621 +2703 6 15.7338 41.7002 0.007017 -29.1796 -38.8659 -6.04008 +2704 4 15.5134 41.1073 41.1476 16.5192 17.684 16.0218 +2705 4 15.1804 41.3134 0.738607 16.9589 18.7767 -12.0866 +2706 6 20.5358 18.4015 7.20723 -36.4209 10.7746 11.3165 +2707 4 20.1727 18.4996 8.12034 18.5895 1.11111 -8.73102 +2708 4 19.7156 18.4439 6.66948 20.5956 -6.66311 2.45516 +2709 6 35.3359 2.82506 1.61733 -4.03181 47.7257 29.2165 +2710 4 34.9541 3.20961 2.47337 19.1106 -23.159 -34.5889 +2711 4 35.8528 3.61912 1.28524 -9.69035 -30.1723 1.40188 +2712 6 49.0059 19.6751 24.9502 -26.306 10.305 -4.58994 +2713 4 49.8292 19.282 24.7191 18.9727 -16.8119 -2.00329 +2714 4 49.219 20.61 24.9195 -6.54834 1.96917 8.98321 +2715 6 26.0427 7.1974 41.5664 19.1127 -25.9459 -27.3591 +2716 4 26.6886 6.46136 41.6822 -6.92827 19.3426 1.38611 +2717 4 25.5576 7.23966 0.456505 -11.7101 6.8047 33.8929 +2718 6 22.0248 3.60461 29.0185 -16.0846 7.25678 -9.40108 +2719 4 21.194 3.80897 28.5456 14.569 -4.87522 0.502932 +2720 4 22.1959 4.40114 29.525 4.81678 0.210141 7.58007 +2721 6 27.8548 32.5394 20.644 30.2008 -27.0251 30.2495 +2722 4 26.9598 32.7332 20.4747 -36.3343 12.7784 -11.814 +2723 4 28.412 33.1097 20.1287 0.615935 11.6015 -11.5439 +2724 6 8.3956 24.7909 3.45677 41.8783 30.6212 2.1827 +2725 4 8.85983 24.2427 2.83372 10.4085 -11.4169 -11.9204 +2726 4 7.65564 24.3184 3.74512 -41.6031 -24.257 6.19876 +2727 6 30.5856 41.7288 15.6573 18.8319 11.6475 40.5199 +2728 4 29.9513 0.161741 16.3149 8.82373 -8.1621 -4.69308 +2729 4 30.0935 41.6309 14.8822 -24.2072 -8.84927 -42.274 +2730 6 48.0984 5.63232 21.2085 -24.8678 -8.67647 -10.7387 +2731 4 47.6235 6.28714 20.6867 8.63769 7.09972 -0.446275 +2732 4 47.3595 5.05066 21.4474 12.3779 0.983941 9.20385 +2733 6 39.4236 23.163 35.7324 -26.6807 -22.8308 -31.4054 +2734 4 39.8477 23.6904 36.3502 31.9199 30.6139 46.0523 +2735 4 38.8623 22.5516 36.2186 -1.29306 -3.58423 7.04543 +2736 6 51.5883 33.3617 5.78995 -19.5798 -55.0773 -18.3228 +2737 4 51.7861 34.2574 5.89467 9.96767 53.6603 7.25336 +2738 4 51.5145 33.1869 4.82901 1.99858 6.27826 11.2132 +2739 6 40.1205 17.6413 30.7797 3.51386 -32.8888 9.0941 +2740 4 39.6335 18.3955 31.0853 6.47279 10.0891 -2.42254 +2741 4 40.8254 17.9321 30.1952 -5.08805 1.72673 -6.80625 +2742 6 46.4235 9.81086 18.5807 -13.6096 13.2326 25.0066 +2743 4 47.164 10.4099 18.4597 3.17276 -2.49269 -0.272695 +2744 4 46.3941 9.2422 17.832 2.02048 -17.819 -25.0993 +2745 6 15.8844 41.0843 31.9336 24.9021 -3.26155 -16.7898 +2746 4 16.5805 40.7078 31.3592 -9.31569 -10.1627 6.74042 +2747 4 16.1791 0.090931 31.8861 -11.051 9.97246 9.22539 +2748 6 48.5496 25.7276 14.9325 -23.4699 4.48431 -20.1118 +2749 4 49.4421 25.9075 14.7294 36.7388 1.67727 3.80263 +2750 4 48.1707 25.827 14.039 -11.0362 0.596064 15.3478 +2751 6 39.2225 28.9892 36.1575 1.81804 -9.3363 -11.5399 +2752 4 40.0459 29.1043 36.6225 6.32097 13.8964 11.0865 +2753 4 39.5169 28.7877 35.2623 -5.25992 -5.15898 -10.721 +2754 6 37.325 21.0738 14.9394 -7.85324 -20.9229 -64.7065 +2755 4 37.9996 20.7799 14.2865 -1.58038 10.9233 26.036 +2756 4 36.5898 21.2349 14.28 11.1979 5.88457 46.2171 +2757 6 32.4971 22.8607 15.7433 -7.91212 -33.4559 24.7905 +2758 4 31.7632 22.4534 15.25 1.55934 10.0805 -2.32687 +2759 4 32.5592 22.2921 16.5663 4.31702 21.463 -27.4441 +2760 6 18.5773 8.13014 37.5708 2.8796 34.5567 21.0854 +2761 4 19.1021 8.93687 37.8089 1.20854 -19.8484 -10.1251 +2762 4 17.9431 8.09722 38.288 -3.97249 -3.14491 3.87795 +2763 6 46.9308 30.3817 11.0144 7.20248 -9.32119 -46.6603 +2764 4 46.4987 30.7035 10.1833 6.25688 -3.94108 30.979 +2765 4 47.431 29.6318 10.6212 -6.26387 6.19468 23.2459 +2766 6 54.6355 13.051 30.6677 -0.631529 -12.3617 0.377161 +2767 4 54.9401 12.1973 31.0202 -4.70537 6.73717 3.83911 +2768 4 54.6706 13.679 31.4001 -0.542159 7.57402 -2.77471 +2769 6 32.2973 35.1412 27.9506 0.702746 7.41177 51.9011 +2770 4 32.3519 35.6753 28.7977 -4.11304 1.55554 -34.3644 +2771 4 32.0809 34.2722 28.2835 1.42742 -15.3938 2.35714 +2772 6 4.45353 25.396 31.7914 -28.2716 -32.1048 1.32297 +2773 4 5.00928 24.905 32.4172 3.79617 9.45861 3.32159 +2774 4 4.83781 26.2295 31.6234 26.2458 34.1175 0.407684 +2775 6 40.7781 38.1509 21.8521 -13.1408 -33.509 11.5706 +2776 4 40.6716 39.044 22.1698 7.33695 21.0707 -1.24628 +2777 4 41.4481 38.0623 21.1738 10.5508 14.8215 -9.14642 +2778 6 26.6931 9.85845 27.4042 -43.8759 24.145 24.882 +2779 4 26.9952 9.1619 26.8761 23.7363 -35.7414 -23.7206 +2780 4 25.7673 9.60487 27.6152 14.5566 8.07269 5.62533 +2781 6 53.3967 39.4485 11.7649 68.843 -10.0355 -14.0333 +2782 4 54.4148 39.3855 11.5456 -53.2103 8.20916 12.7106 +2783 4 53.105 40.2482 11.2866 -1.29569 -7.05369 14.3337 +2784 6 35.3292 21.4155 2.23587 15.106 -7.83484 -18.4876 +2785 4 34.912 20.5764 2.48744 -1.27765 6.93695 -0.309601 +2786 4 35.8084 21.2289 1.37944 -21.1629 3.53466 26.6292 +2787 6 4.14409 17.1449 33.9131 -16.1644 -22.9901 22.0601 +2788 4 4.14131 16.4411 34.6063 8.69636 10.7601 -14.4963 +2789 4 3.20404 17.192 33.6728 6.06844 1.20479 -9.99864 +2790 6 24.1486 16.1886 14.6752 2.90394 -28.6462 -21.9437 +2791 4 24.2343 17.059 15.0346 0.494679 15.8947 1.83084 +2792 4 23.7735 16.3203 13.7888 -2.47926 -0.947779 4.85435 +2793 6 43.1303 2.83022 26.0988 7.42094 18.4339 -15.1049 +2794 4 42.3152 3.21229 26.4285 -6.54764 -1.84254 4.96768 +2795 4 43.2129 3.23454 25.2082 4.91034 -11.1878 11.8147 +2796 6 40.68 12.1827 1.56051 12.2683 5.96873 16.2718 +2797 4 41.5968 12.2158 1.84207 12.0551 -6.37233 -9.83141 +2798 4 40.2741 12.5174 2.36876 -21.9125 -2.35909 -10.0625 +2799 6 47.3781 8.09655 26.7608 82.0606 26.064 -7.54845 +2800 4 46.666 7.67998 26.3919 -67.6244 -33.3987 -26.4118 +2801 4 48.0445 8.01522 26.0221 -12.6559 5.80771 33.8866 +2802 6 35.8947 30.7223 38.5098 17.2216 52.6179 -38.6143 +2803 4 35.6523 29.9703 39.0072 10.7188 -28.2359 27.6772 +2804 4 36.8587 31.0199 38.5623 -37.3038 -25.1724 3.03639 +2805 6 51.3054 23.2176 32.4969 -40.2617 11.1267 -4.72183 +2806 4 51.571 23.9803 31.9692 8.10126 9.10595 3.65824 +2807 4 52.0738 22.7076 32.6523 27.5758 -14.8312 4.00399 +2808 6 30.6066 4.44965 39.6625 0.615077 -4.04577 -5.4494 +2809 4 30.9728 3.64581 40.0124 3.38991 -22.1323 -0.234101 +2810 4 30.7691 5.02119 40.3987 0.467535 29.3806 6.08815 +2811 6 35.2584 29.6988 2.86074 -18.8762 -20.4699 -30.2285 +2812 4 35.7444 29.7805 2.00551 -3.31399 -2.84145 17.507 +2813 4 34.478 29.0852 2.62897 29.9452 30.586 13.9144 +2814 6 50.3064 26.1399 9.38994 -11.2342 14.6262 -3.47403 +2815 4 49.9288 26.8854 8.86032 11.0364 -25.2497 6.23881 +2816 4 49.6695 25.4035 9.37359 7.94529 9.32604 -3.86417 +2817 6 50.1026 36.8163 26.4125 -14.5138 -5.51826 -11.285 +2818 4 49.5888 36.0167 26.6617 3.79204 13.187 5.56915 +2819 4 50.2319 37.3727 27.1922 -3.20057 1.11223 6.19844 +2820 6 40.3045 23.9511 38.5442 56.3682 27.7758 -3.16545 +2821 4 40.8125 24.7624 38.7991 -6.5383 -29.3065 -12.768 +2822 4 39.4568 24.2221 38.8139 -44.6373 -1.162 12.0349 +2823 6 24.9504 10.7612 30.6561 23.3702 -4.90777 36.4738 +2824 4 25.6234 10.7245 31.4083 -25.7901 9.07318 -40.0098 +2825 4 24.9126 11.6687 30.2959 1.4184 -10.5997 2.42613 +2826 6 5.89627 1.02238 5.41014 -10.9637 -3.10309 -8.95081 +2827 4 5.14436 0.409378 5.47088 11.7326 -0.810065 6.31118 +2828 4 6.70289 0.529043 5.60145 -0.696658 -1.4992 -0.407558 +2829 6 44.282 29.3718 26.2736 69.4655 -24.0165 25.5627 +2830 4 43.5561 29.7046 25.8233 -49.9183 11.7173 -34.3685 +2831 4 44.8903 28.8623 25.6892 -19.9675 5.54095 9.74148 +2832 6 25.3119 10.1784 6.67292 -15.7736 -23.3412 -3.06725 +2833 4 25.6521 11.0537 6.64576 10.6351 24.7362 -4.37451 +2834 4 25.4625 9.79379 5.79618 6.21987 0.326131 1.26241 +2835 6 13.3514 28.0662 2.56722 45.2358 13.6418 17.9819 +2836 4 12.4545 27.8107 2.56105 -32.9681 -11.4511 -11.8173 +2837 4 13.8041 27.7134 1.79344 -6.10921 -0.687749 -0.120894 +2838 6 6.44709 40.2351 18.0254 21.2427 9.30891 -1.39987 +2839 4 6.966 39.4726 17.7533 0.137807 -7.29984 6.20872 +2840 4 5.59682 40.0602 17.6456 -22.1821 0.316247 -4.7234 +2841 6 47.7944 13.5061 2.01255 -17.6425 -30.8617 30.605 +2842 4 48.2016 12.6358 2.19438 -7.04124 7.54818 -3.24284 +2843 4 48.4122 13.9735 1.50015 28.8905 20.8749 -24.4455 +2844 6 13.5944 20.2974 2.4458 20.0315 11.2691 18.6487 +2845 4 13.7883 19.6075 3.10831 1.39134 9.87367 -8.40212 +2846 4 13.0064 19.8713 1.85297 -21.5499 -10.3053 -19.2062 +2847 6 15.2336 0.850818 36.6661 8.37652 40.6516 -23.9146 +2848 4 15.3117 1.46746 37.4264 -6.40063 -24.0213 -7.24367 +2849 4 15.3514 1.51981 35.909 -6.71396 -40.605 26.1829 +2850 6 33.5971 35.2491 15.0847 71.6425 -10.6997 11.4711 +2851 4 33.8969 35.3297 16.0058 -20.0956 -0.49545 -2.4869 +2852 4 34.508 35.0431 14.6807 -47.978 4.31732 -2.67502 +2853 6 21.7981 9.23698 0.429299 24.0185 -25.5324 29.6504 +2854 4 22.426 9.07175 41.6424 8.6426 -4.20457 -11.04 +2855 4 21.1884 9.81045 0.032847 -35.1273 25.1593 -17.3244 +2856 6 38.1453 27.4709 3.0333 47.9463 -55.6761 10.6859 +2857 4 37.7532 27.3037 2.19157 -17.0599 1.14667 -24.2168 +2858 4 37.8405 28.2288 3.44687 -27.291 50.0057 16.1216 +2859 6 38.8714 27.215 11.7709 41.141 -36.7506 -15.3879 +2860 4 38.9285 26.3434 12.2193 -14.3396 10.7389 0.963039 +2861 4 39.5886 27.0941 11.0922 -22.6073 11.6268 16.0227 +2862 6 29.8734 41.5737 28.6987 15.2279 35.2113 -10.5566 +2863 4 28.9552 41.3162 28.7047 -13.1778 -5.77603 2.88395 +2864 4 29.9141 0.263017 27.9132 -0.896253 -12.9147 16.3719 +2865 6 34.03 8.70777 38.0687 38.5763 27.6628 16.1728 +2866 4 34.8607 8.18924 38.1985 -14.88 11.0383 -8.6682 +2867 4 33.3419 8.15213 37.7593 -24.3719 -27.4308 -8.08559 +2868 6 38.8091 27.3495 30.6738 6.32435 -21.1782 -4.52762 +2869 4 38.5154 26.4386 30.4378 -1.34454 21.7952 1.35616 +2870 4 38.3686 27.5808 31.4849 -11.9448 1.82739 7.69603 +2871 6 41.6473 17.269 36.3639 7.45605 15.5752 1.52238 +2872 4 41.3137 17.162 35.483 -10.4634 0.342165 -15.0979 +2873 4 41.7169 16.3923 36.7151 5.72978 -18.5967 8.16978 +2874 6 30.7243 26.977 35.2074 -15.5404 -28.2563 -3.1326 +2875 4 31.3953 27.4345 34.7177 18.5093 15.4635 -5.31058 +2876 4 30.2206 27.5565 35.766 -0.690558 20.2492 9.56945 +2877 6 47.5414 4.09198 27.2867 -2.42911 13.6608 18.2544 +2878 4 46.636 4.37242 27.4325 -10.4037 -2.52064 9.15115 +2879 4 47.5606 3.99786 26.3497 6.55325 -3.96267 -23.0579 +2880 6 20.946 8.39203 7.27322 -27.8597 -45.7319 -0.818331 +2881 4 20.9365 8.74812 8.15774 -0.207227 20.4039 13.5637 +2882 4 21.4094 8.93893 6.67191 21.7448 31.5979 -18.7028 +2883 6 36.8544 13.691 0.855516 -6.96494 -6.58957 -4.7536 +2884 4 37.3845 13.474 1.605 15.5913 2.53244 29.7992 +2885 4 37.0002 12.9032 0.328977 -4.78774 -2.28905 -12.5933 +2886 6 28.5904 20.2994 26.4544 16.2695 -3.42806 -15.5352 +2887 4 28.4835 19.402 26.1318 -1.12761 -3.3858 2.90642 +2888 4 27.7814 20.5406 26.8733 -22.93 6.76513 15.2817 +2889 6 51.6079 16.8571 33.5121 -4.50033 -4.43314 5.93611 +2890 4 51.6159 16.0837 34.101 -3.91985 -0.958274 -7.09147 +2891 4 50.9053 16.6875 32.8669 7.1497 -2.58651 -2.16023 +2892 6 16.2715 32.0073 37.6936 -41.8913 -21.032 -18.7972 +2893 4 16.4093 31.405 38.4555 0.0363557 12.0183 -19.687 +2894 4 15.4977 31.6058 37.1477 38.3353 16.8511 22.6146 +2895 6 14.3407 25.877 13.2155 1.26588 11.3619 -17.2713 +2896 4 13.5013 26.0279 13.6901 5.40221 7.27027 -0.947788 +2897 4 14.4551 26.5608 12.5093 -9.57117 -0.277473 20.5459 +2898 6 54.9749 28.8768 3.30374 1.15612 -53.5629 -1.59986 +2899 4 54.8083 28.9028 2.3467 2.04661 0.129141 5.0455 +2900 4 0.26744 27.9124 3.48546 -12.4506 41.1861 -2.95604 +2901 6 17.22 5.15598 2.57931 -12.7888 -35.846 -9.7104 +2902 4 17.8674 4.52191 2.91459 -1.87097 -9.90488 -4.08214 +2903 4 17.421 5.9071 3.09191 1.36943 25.6696 10.0797 +2904 6 50.6995 33.0507 10.3154 6.59719 15.9916 42.5002 +2905 4 50.6222 33.8517 9.79386 -1.28667 2.08485 -11.8542 +2906 4 50.7575 32.2667 9.79209 -3.80283 -15.7636 -22.9095 +2907 6 28.8826 19.8405 32.3742 18.5732 17.2051 -15.397 +2908 4 29.8373 20.0763 32.2 -31.4986 -11.6613 7.66973 +2909 4 28.4094 20.6578 32.1253 1.55933 -8.77069 7.582 +2910 6 22.4307 12.8248 23.2991 -20.6917 10.5217 33.6658 +2911 4 22.5556 12.3422 24.1574 -2.40655 13.6672 -16.3005 +2912 4 21.7108 13.488 23.4947 18.3613 -16.8762 -11.246 +2913 6 54.7763 15.5394 8.86893 2.10476 3.1215 13.1486 +2914 4 0.465115 15.309 9.51431 10.762 -2.70861 -3.02895 +2915 4 53.9989 15.1653 9.30174 -3.31272 -0.629746 -12.248 +2916 6 10.4518 19.2967 26.1704 43.67 -11.1159 60.7251 +2917 4 11.2502 18.7163 26.2348 -22.5321 13.8961 -6.48776 +2918 4 10.166 19.2541 25.3007 -24.1973 -3.18459 -58.4054 +2919 6 38.6496 20.2998 35.2325 20.2193 -0.813999 -8.63065 +2920 4 39.5955 20.3672 34.9603 -17.6326 -1.16496 9.70871 +2921 4 38.5782 19.6093 35.9099 2.97533 6.68842 -2.65526 +2922 6 17.4906 18.0487 15.2499 -10.3405 45.0299 20.0184 +2923 4 17.3837 17.5615 14.4531 -8.22833 -15.0257 -32.2828 +2924 4 17.2318 18.9864 14.9797 13.5676 -28.3997 10.204 +2925 6 29.6331 0.960567 26.2796 -25.6031 -26.3316 -72.4206 +2926 4 29.3216 1.74647 25.7973 3.40072 6.61544 23.4347 +2927 4 29.2407 0.266373 25.6265 23.6279 16.4272 47.4057 +2928 6 30.4665 12.6849 28.2971 -10.7965 -27.9245 1.17671 +2929 4 29.8272 13.0822 27.7097 -1.40549 16.7134 -9.61387 +2930 4 30.1324 11.7665 28.3519 9.60572 9.94425 5.65357 +2931 6 36.6695 22.1225 33.3577 39.6017 -11.6369 -25.7224 +2932 4 37.5338 21.6663 33.4931 -10.4393 24.3252 -8.31461 +2933 4 36.1732 21.6976 34.0074 -34.1256 -9.27026 38.9845 +2934 6 34.8672 22.4666 14.3113 -12.0535 -16.0605 -66.2467 +2935 4 34.0349 22.4515 14.7407 -19.1997 11.5289 38.0952 +2936 4 34.5417 22.174 13.4128 25.6484 2.69091 24.3313 +2937 6 15.5262 9.60919 7.44527 49.3682 -27.3699 -19.0187 +2938 4 16.547 9.52246 7.26069 -54.7763 6.57045 5.33777 +2939 4 15.1277 8.71762 7.26288 7.76902 16.5773 17.8238 +2940 6 21.8158 28.0339 19.8054 -4.91607 2.79332 -16.2053 +2941 4 21.8614 28.4614 20.6522 -2.04715 7.82991 15.4338 +2942 4 20.8734 27.9328 19.6183 -0.9528 -10.4666 6.26348 +2943 6 34.5348 24.4247 2.43569 30.4222 -68.2311 14.7367 +2944 4 34.4753 23.4054 2.32054 1.69344 45.6403 0.121788 +2945 4 35.3397 24.4934 3.03523 -29.9154 15.8849 -16.545 +2946 6 12.599 20.9348 33.4989 -13.8827 -5.0407 19.8786 +2947 4 11.7591 20.6911 33.9854 14.8004 1.51093 -27.4282 +2948 4 12.4712 20.9089 32.5331 -6.4324 -2.96843 13.903 +2949 6 45.7737 31.1538 8.70434 -2.26925 11.3362 1.64289 +2950 4 45.9542 32.0869 8.96415 -8.39554 -11.7705 -15.6468 +2951 4 44.8313 30.9442 8.82297 5.93432 7.3758 2.64979 +2952 6 15.4817 22.5529 30.1787 5.69125 -30.6905 2.54506 +2953 4 16.2669 22.9885 30.4865 5.73919 23.8488 1.47991 +2954 4 15.7828 21.6299 30.2043 -15.5749 7.04719 -4.74998 +2955 6 39.7421 17.1743 38.4094 21.5551 17.0277 -9.47446 +2956 4 39.5031 16.7163 37.59 -3.21419 -6.16335 13.1695 +2957 4 40.5012 17.7258 38.123 -12.3818 -10.233 9.13463 +2958 6 13.9944 24.6739 0.675362 16.6213 17.4065 1.77653 +2959 4 14.3534 24.6315 1.57006 -7.52322 -5.04497 4.60086 +2960 4 14.2363 25.5684 0.403337 7.11699 -3.23043 -4.31609 +2961 6 31.5223 19.5616 3.57151 -53.5885 6.24325 20.3398 +2962 4 30.9852 19.2876 4.35912 8.49606 10.2921 -25.2864 +2963 4 32.3806 19.3906 3.88708 44.0272 -8.41539 -5.41474 +2964 6 36.1052 25.07 19.4414 -58.1964 5.4792 30.944 +2965 4 37.0178 24.9674 19.4291 53.7837 8.57858 1.17104 +2966 4 35.8724 24.6048 18.6565 -11.4284 -6.26335 -25.0938 +2967 6 51.6856 17.6883 14.8068 3.37141 18.4291 36.2611 +2968 4 51.7159 18.5692 15.274 12.631 -26.1695 -13.2311 +2969 4 51.0805 17.8845 14.1157 -15.036 4.32684 -29.7308 +2970 6 37.7054 27.4905 38.1961 21.1085 51.9404 -4.50496 +2971 4 37.7442 26.8536 37.5026 -5.7586 -24.9449 -15.2301 +2972 4 38.1753 28.2651 37.7886 -14.569 -23.1779 14.5181 +2973 6 34.7911 13.8542 30.7834 63.814 8.34946 -38.9004 +2974 4 35.1479 14.6416 31.2053 -8.52888 3.60926 11.6955 +2975 4 33.9958 13.5796 31.1473 -54.5977 -12.3598 32.1143 +2976 6 19.6332 37.3754 39.9698 -24.3625 -2.8653 -8.02349 +2977 4 20.5737 37.5051 40.1221 10.6449 -2.37562 -1.97502 +2978 4 19.476 36.9037 39.1231 9.83703 4.21653 7.37417 +2979 6 40.9393 34.0697 21.4586 2.1394 -11.0927 -27.2527 +2980 4 41.1855 34.0244 22.3739 -0.995015 -5.02364 12.6588 +2981 4 40.8269 33.1391 21.1809 -5.56645 12.5591 1.05516 +2982 6 32.9542 27.2131 26.5676 21.8236 31.3611 42.3808 +2983 4 33.7455 27.7378 26.9411 -38.3522 -19.3744 -9.62352 +2984 4 33.2804 26.8388 25.7801 14.7034 -8.88898 -37.5519 +2985 6 24.4045 18.6625 15.6046 15.6323 5.3487 0.0952382 +2986 4 23.6496 19.2317 15.7207 -14.8084 -1.4602 1.41466 +2987 4 24.5649 18.2576 16.462 -0.219489 -3.50303 9.55317 +2988 6 29.9663 1.63299 9.06934 -19.1782 58.0281 -13.4952 +2989 4 30.0652 0.728361 9.20589 6.15764 -53.3299 8.23098 +2990 4 29.142 1.69178 8.53744 13.8409 -0.846673 8.85197 +2991 6 31.4884 20.0987 7.87879 28.0207 -11.7442 -56.0977 +2992 4 31.929 19.6692 7.07379 -7.62771 20.3934 38.6055 +2993 4 30.8102 19.4535 8.0257 -16.4635 -8.90407 20.6678 +2994 6 35.0404 3.79156 33.2694 -1.07326 -4.91424 22.8916 +2995 4 34.2545 4.23611 32.9039 10.815 -2.65177 -4.17514 +2996 4 34.969 3.91026 34.2418 -2.62674 -1.77539 -18.1187 +2997 6 43.9504 7.96546 12.9857 17.1829 -21.9111 0.113786 +2998 4 43.3325 7.29581 13.3448 8.44862 12.3123 -3.96012 +2999 4 43.4563 8.73573 12.7333 -15.1408 11.4953 0.0339333 +3000 6 44.1156 32.6759 16.9403 5.31814 23.9263 4.94933 +3001 4 44.7028 33.4557 16.8081 -6.11209 -18.3833 -3.28173 +3002 4 44.1603 32.5425 17.8901 -3.26507 -3.06823 6.73624 +3003 6 40.6044 27.171 19.0399 5.35236 -7.54795 -39.8413 +3004 4 39.9756 26.4797 18.7399 3.73803 11.5815 8.49028 +3005 4 41.0398 27.5246 18.2027 -12.4172 -8.32437 32.3474 +3006 6 46.047 23.2024 29.047 17.2683 37.2743 26.3298 +3007 4 46.6657 23.8797 29.4684 -18.5589 -27.346 -17.4569 +3008 4 46.486 22.3548 28.9238 8.34839 -6.65718 2.80441 +3009 6 42.6215 30.6103 18.862 -5.01232 -15.325 -26.4249 +3010 4 43.5272 30.7476 19.0895 18.324 11.0008 12.4889 +3011 4 42.704 29.9429 18.1625 -17.0641 3.12823 2.85026 +3012 6 36.1251 10.8932 23.2678 23.6581 36.1082 4.04534 +3013 4 35.2523 11.2865 23.1129 -2.80799 -1.69562 1.02392 +3014 4 36.6983 11.6913 23.4963 -28.2294 -33.6871 -7.78786 +3015 6 13.7386 31.5223 15.7271 -4.49361 3.73805 -16.8081 +3016 4 14.6779 31.7192 15.7387 3.94655 -1.56597 5.72926 +3017 4 13.381 32.0318 14.979 -1.5565 -4.12563 8.0657 +3018 6 33.1703 41.4275 27.7797 10.5813 -15.702 68.4674 +3019 4 32.9714 0.101499 27.0951 -7.66273 31.9341 -41.1766 +3020 4 33.2579 0.043937 28.6255 4.60937 -17.5422 -27.6682 +3021 6 32.9019 22.9042 31.4856 -22.5274 37.748 -5.90861 +3022 4 32.2895 23.1741 30.7829 6.44322 -22.1433 -13.1277 +3023 4 32.7242 23.6662 32.0583 13.0029 -8.58894 11.8377 +3024 6 27.6559 16.8629 6.38841 0.759442 -6.33883 29.8789 +3025 4 27.8611 17.2083 5.54221 8.69809 17.4791 -25.8043 +3026 4 26.8031 16.4594 6.24591 -13.957 -6.38022 2.63501 +3027 6 47.2651 11.6173 26.0576 8.33461 35.0159 47.6166 +3028 4 47.0912 11.6838 27.0214 -5.10661 -22.4254 -22.6877 +3029 4 47.7461 12.4597 25.9756 -3.10554 -9.06377 -24.8427 +3030 6 27.5595 7.06242 7.64189 36.0057 -29.1625 5.70238 +3031 4 26.7484 7.49683 7.83093 -25.0876 11.7282 17.2448 +3032 4 28.0841 6.86482 8.45622 -15.7481 15.6684 -17.1357 +3033 6 39.8009 9.06823 11.973 -19.1879 4.0297 -12.8881 +3034 4 39.4826 9.27056 11.0665 6.39012 -4.37616 15.6201 +3035 4 38.9894 9.1094 12.5089 2.28999 7.64442 -1.09803 +3036 6 18.1977 33.4656 36.103 -47.2434 1.22325 7.58723 +3037 4 17.6693 33.9565 35.4324 13.0563 -6.22307 9.58411 +3038 4 17.491 33.069 36.7104 31.5801 5.82297 -20.8408 +3039 6 37.1917 26.5507 0.720984 -4.45309 15.6177 5.32368 +3040 4 37.3846 25.6567 0.44907 -1.85313 -8.64798 -1.56679 +3041 4 36.2207 26.6114 0.739208 8.96605 -1.46339 -9.13916 +3042 6 44.1887 19.6251 36.8885 40.0452 -6.58607 -3.19327 +3043 4 45.0262 19.1233 36.6753 -25.2412 9.90919 11.1214 +3044 4 44.4881 20.5478 36.9825 -7.95545 -4.32402 -1.12283 +3045 6 27.7744 6.35339 35.6933 13.1235 -8.00403 1.40836 +3046 4 27.1655 6.97567 35.3121 -8.4989 9.93248 -6.95364 +3047 4 27.2748 5.53908 35.7675 0.865215 -2.72076 5.22838 +3048 6 34.7673 16.4826 20.8897 25.0208 -26.1622 5.09639 +3049 4 35.5801 15.8751 20.9364 -40.3091 28.8833 0.638889 +3050 4 34.1629 16.1653 21.5964 8.34467 8.45669 -12.6288 +3051 6 39.0349 20.9701 40.4369 -35.0548 -83.2732 -20.3586 +3052 4 38.7355 20.0763 40.8679 21.616 52.9309 -20.1646 +3053 4 39.3277 21.5521 41.0958 10.956 28.6509 41.127 +3054 6 10.8075 27.9275 1.66251 45.0798 11.5101 -39.3642 +3055 4 10.1207 27.6506 2.20454 -46.3214 -11.9312 37.0665 +3056 4 10.864 28.8887 1.77269 -0.956148 -2.75571 -0.87801 +3057 6 47.0235 23.1304 13.2457 -34.1648 -14.46 -9.62139 +3058 4 47.6809 23.5773 12.718 7.19949 7.22116 -4.18429 +3059 4 46.2703 22.9258 12.6132 27.3011 3.73645 28.26 +3060 6 34.5862 28.4037 10.6629 -11.4192 -4.75939 1.42695 +3061 4 34.4799 27.7252 11.3319 -5.35328 -3.69815 4.40234 +3062 4 35.5403 28.4214 10.6073 9.29856 11.2923 -14.2157 +3063 6 3.3474 17.5828 14.2796 -19.4871 24.8451 -12.2706 +3064 4 3.54237 16.6973 14.5399 7.15819 -24.2504 13.4427 +3065 4 3.84281 18.1577 14.8755 9.98901 -5.90389 -1.38432 +3066 6 27.7213 11.5993 7.52196 5.39723 39.0715 -5.17771 +3067 4 27.6701 12.604 7.61024 4.43832 -37.6789 -1.1729 +3068 4 27.2296 11.2227 8.25132 -2.72363 -3.1191 8.53492 +3069 6 41.4314 28.3382 9.01837 19.0589 -0.973961 -18.7609 +3070 4 40.8555 28.7961 9.62238 -6.75468 20.1798 6.66135 +3071 4 41.7073 28.957 8.28743 -10.8025 -14.2077 17.7393 +3072 6 42.0854 4.7797 8.18851 -21.257 14.5957 -52.3899 +3073 4 42.0432 5.70949 7.81908 14.9695 -22.9802 20.9203 +3074 4 41.8649 4.22501 7.38905 12.6142 12.8494 32.4876 +3075 6 28.4682 8.6325 40.3242 -61.7219 6.47809 -5.55454 +3076 4 27.7379 8.57122 40.9835 27.869 -4.13123 -2.00049 +3077 4 27.8882 8.69791 39.5144 34.8971 -1.31486 9.68376 +3078 6 0.711352 18.2475 15.2828 -1.03732 14.0577 26.4962 +3079 4 1.6037 18.2498 14.9622 18.0256 -6.96047 -13.9963 +3080 4 0.201613 17.7329 14.6701 -10.6254 -13.4061 -11.9404 +3081 6 7.11345 16.2289 40.4432 8.45023 -35.9074 47.1296 +3082 4 7.17312 15.3057 40.7986 -0.221024 11.0765 -27.8146 +3083 4 7.22051 16.6703 41.3088 -5.23596 22.4775 -22.5048 +3084 6 41.0858 8.62552 20.9048 11.0684 -11.3616 26.0286 +3085 4 40.3918 8.42716 20.2762 -10.0062 9.73992 -12.3328 +3086 4 41.3944 9.53753 20.8124 -4.81268 6.06535 -10.7329 +3087 6 31.7073 7.42286 37.542 -14.8479 -9.90339 6.69006 +3088 4 31.4959 7.12404 36.6506 2.47263 0.526998 -6.01676 +3089 4 30.9335 7.11441 38.0458 14.4773 7.59586 -0.291785 +3090 6 40.7266 11.6476 25.425 -35.4896 13.4329 -16.1803 +3091 4 40.7395 12.5913 25.6925 9.9362 -18.5419 -7.18222 +3092 4 41.5423 11.2236 25.6435 22.7694 -4.71413 12.394 +3093 6 29.8665 30.1579 6.66307 26.6562 -4.16721 8.5177 +3094 4 30.5555 30.7343 6.31583 -2.18777 1.73834 -10.5199 +3095 4 30.3573 29.3259 6.76714 -13.2281 -1.59651 -6.45815 +3096 6 40.8439 24.5837 5.68012 15.8615 33.1962 -4.14396 +3097 4 41.3457 25.4223 5.9023 -8.27611 -29.5734 -8.52614 +3098 4 40.1119 24.5659 6.27901 -12.3156 -1.80355 11.8721 +3099 6 34.3917 9.09675 20.4219 17.6262 -1.15942 17.9162 +3100 4 33.57 9.43601 20.7884 -5.86563 4.88571 -3.34935 +3101 4 34.2167 8.80099 19.5352 -13.2656 -6.03918 -15.2606 +3102 6 18.2311 33.5548 26.5354 9.60899 -55.578 -54.4315 +3103 4 19.159 33.2107 26.4405 -23.3884 24.4218 8.45675 +3104 4 18.1621 34.044 27.3085 3.33799 34.4716 53.9641 +3105 6 28.9072 17.4193 26.7965 8.90265 -1.34032 10.3526 +3106 4 28.3267 16.8801 26.2506 -9.53448 5.67773 -5.57268 +3107 4 28.3756 17.7646 27.5432 9.63981 -8.23286 -8.72686 +3108 6 50.4255 35.5446 18.192 14.112 9.6817 -2.74072 +3109 4 50.5661 35.3326 17.2487 -8.6314 -7.47676 15.7559 +3110 4 50.5766 34.7477 18.7329 -11.9848 3.75846 -10.2286 +3111 6 2.99463 21.5653 31.4474 1.68271 -21.0005 -22.757 +3112 4 3.33698 22.262 30.8385 -11.1525 -11.1618 12.076 +3113 4 2.83901 20.7479 30.8788 5.9339 29.1288 19.4027 +3114 6 36.1811 18.7457 8.60665 26.0746 50.7707 2.54435 +3115 4 36.1969 17.9289 9.04749 -6.79937 -48.2248 12.3681 +3116 4 35.6147 18.7828 7.85483 -18.853 -7.00319 -22.0811 +3117 6 20.2934 6.48366 33.7248 -33.7925 -21.1439 9.08779 +3118 4 19.8228 6.33509 34.5702 11.9648 11.0481 1.53323 +3119 4 19.9109 5.73333 33.234 17.8653 6.32962 -8.93867 +3120 6 14.0016 30.5326 6.65439 -2.06342 0.226434 14.1624 +3121 4 14.6658 31.0189 7.18657 -8.4774 -5.82658 -13.2159 +3122 4 13.1556 30.6664 7.11082 5.19683 1.19435 -6.65694 +3123 6 36.2738 16.4523 35.7634 28.7444 28.7466 -1.25628 +3124 4 37.2529 16.3082 35.8444 -30.8138 -2.80693 3.80535 +3125 4 36.1869 17.4417 35.6433 -1.25715 -33.4762 0.326736 +3126 6 45.8255 37.6646 9.68707 16.0609 -41.2042 -13.6418 +3127 4 45.4852 38.2919 10.2717 -20.4348 34.8513 25.7777 +3128 4 46.231 37.0083 10.2774 7.06244 2.74597 -12.4723 +3129 6 47.4229 17.9968 27.6368 -1.79372 -57.0164 -4.60636 +3130 4 47.566 17.432 26.8065 -4.8869 24.4286 27.8294 +3131 4 47.3631 17.3546 28.4089 6.87022 22.2846 -25.0829 +3132 6 25.9574 18.2976 0.964228 23.0858 -4.77958 -10.3735 +3133 4 26.3734 18.9022 1.60725 -19.9671 -4.02324 -2.33442 +3134 4 24.9961 18.2982 0.948557 -9.32218 6.60301 10.8105 +3135 6 27.3657 22.4026 4.28337 1.04907 -15.9856 -17.2206 +3136 4 27.2658 23.3197 4.47064 2.83879 26.7243 10.1579 +3137 4 27.3462 22.4079 3.3181 -1.05974 -10.8362 7.50108 +3138 6 3.39902 3.84297 27.6033 -32.797 -16.937 8.3321 +3139 4 3.87422 4.64571 27.4715 26.6916 15.5682 -1.1402 +3140 4 3.96055 3.06079 27.6076 7.92228 2.5358 -5.38712 +3141 6 45.3564 27.6573 28.835 13.8657 -6.64535 19.4164 +3142 4 44.592 27.1099 28.6295 -10.1072 2.65107 -0.516215 +3143 4 45.3903 28.3299 28.161 -2.22034 5.33578 -9.67936 +3144 6 28.3928 32.384 16.2149 35.1766 -7.36337 1.61596 +3145 4 29.2284 32.2059 15.7054 -23.0821 5.0916 11.0276 +3146 4 28.7076 32.6186 17.1078 -8.03404 1.42552 -9.59962 +3147 6 9.90485 33.8293 13.0286 10.5996 -3.42126 36.647 +3148 4 9.63365 33.2371 13.7754 2.50037 15.8816 -14.8106 +3149 4 9.32864 33.6931 12.2897 -16.1444 -6.90665 -19.0975 +3150 6 38.3335 26.6343 14.9205 -0.551684 -24.4487 3.86314 +3151 4 38.658 25.7334 15.149 1.53578 20.736 -5.06851 +3152 4 37.3858 26.5974 15.0972 1.00556 4.30146 -0.183996 +3153 6 31.3571 16.3836 4.2445 -16.7299 -18.7641 16.8138 +3154 4 30.5501 15.9079 4.56795 14.9054 8.61271 -6.80276 +3155 4 31.2311 16.4593 3.29715 -1.72501 9.16645 -9.12782 +3156 6 6.17482 3.39637 6.55833 17.6941 29.4886 56.031 +3157 4 6.41103 3.08651 7.49149 -7.06328 10.7723 -41.2395 +3158 4 5.9143 2.63963 6.07247 -2.51266 -29.5732 -15.1374 +3159 6 42.5954 13 5.61529 2.6815 -10.2341 6.00586 +3160 4 42.2228 13.83 5.89445 -1.70762 9.74234 -1.3058 +3161 4 43.4476 12.9425 6.06763 3.18432 -3.38396 -9.63491 +3162 6 41.0469 31.4032 33.8032 -2.41258 31.7421 -2.74763 +3163 4 40.7074 31.3974 34.7214 7.44932 1.1292 -16.4995 +3164 4 41.1575 32.3688 33.5162 -1.31614 -41.8694 16.6901 +3165 6 52.8576 12.0626 26.2641 9.5895 -24.4248 -55.9842 +3166 4 52.4684 12.727 26.7939 -19.7064 26.0739 18.5009 +3167 4 52.6066 12.2568 25.3043 12.3637 -4.77707 33.6793 +3168 6 39.2086 4.29542 29.0724 8.4008 5.1904 -7.5125 +3169 4 38.4444 4.85752 29.2861 11.0986 -5.7068 1.32154 +3170 4 39.9986 4.64958 29.5231 -9.05665 -5.78587 -2.57989 +3171 6 3.65769 27.0104 11.285 -33.2394 -3.70913 -3.8751 +3172 4 4.59992 26.8829 11.3514 17.6792 2.33561 -5.11125 +3173 4 3.4519 27.7953 10.7423 10.2361 0.60791 3.91121 +3174 6 41.5441 29.6402 25.2654 2.79284 -4.6021 22.0238 +3175 4 41.8464 29.7038 24.3667 4.04268 2.71218 -16.2057 +3176 4 40.7127 30.1073 25.3399 -6.11251 5.69311 -9.79107 +3177 6 50.4754 27.4974 30.671 -6.87832 -12.1873 7.27551 +3178 4 50.0778 27.1279 31.4799 3.22248 2.82006 -4.01445 +3179 4 49.7824 27.9982 30.2275 0.0461655 4.73 -3.38362 +3180 6 32.7876 33.6322 41.7537 -8.7541 -8.89692 -39.0089 +3181 4 33.1671 32.7559 41.8028 5.47994 -11.5785 5.15438 +3182 4 32.9083 34.029 0.675063 4.83491 15.974 33.6037 +3183 6 5.9806 9.64323 7.93715 4.3965 6.41539 -15.2951 +3184 4 5.77829 9.93579 8.8312 0.6559 3.73469 4.68299 +3185 4 6.3228 10.4083 7.4265 1.56495 -8.59939 9.02132 +3186 6 52.7884 25.3949 27.7 -7.43266 -9.74322 -1.44878 +3187 4 52.93 26.351 27.8747 -0.851616 -24.8244 8.41831 +3188 4 52.9998 24.8518 28.4994 7.3809 16.2458 -18.9874 +3189 6 18.6796 23.2043 14.4609 8.49541 46.7244 28.1607 +3190 4 18.697 24.1166 14.872 -21.1178 -26.825 -16.729 +3191 4 19.5981 23.1771 14.2416 15.365 -21.3066 -15.3625 +3192 6 31.2857 9.07887 13.0786 26.2489 -54.2202 -11.3888 +3193 4 31.3193 8.20519 13.5416 -2.63874 16.5358 -10.154 +3194 4 30.7972 9.64602 13.6278 -24.9284 29.9413 31.6235 +3195 6 52.8163 16.833 29.9704 25.4684 -2.46115 -18.7711 +3196 4 53.1785 16.3479 29.2052 -11.8989 0.938692 6.7974 +3197 4 53.5445 17.4528 30.1342 -3.36222 3.81908 9.3955 +3198 6 13.4835 30.6533 11.9137 -46.9609 -12.8402 15.0292 +3199 4 12.8701 31.2475 12.4314 22.3442 -12.341 -15.3642 +3200 4 14.3315 31.0589 11.9363 20.4041 22.2607 2.0467 +3201 6 24.4145 24.6647 11.1793 -22.2983 -41.6602 -10.5575 +3202 4 25.2113 25.1208 11.3859 27.2622 9.38308 11.5927 +3203 4 24.6402 23.6908 11.0915 -11.4513 27.6962 10.6476 +3204 6 11.1203 26.798 5.92715 -0.288466 28.8994 -0.991584 +3205 4 11.4516 26.991 6.8143 4.21529 -7.59652 -0.673238 +3206 4 11.0194 27.7223 5.58288 -7.6649 -30.4822 0.0195949 +3207 6 12.0071 32.3096 4.57291 -4.86243 14.2275 -68.6847 +3208 4 11.7793 31.9281 3.63093 8.01684 14.4954 56.5286 +3209 4 12.2995 33.2463 4.37904 -4.11207 -26.5611 6.70158 +3210 6 6.4322 5.49281 30.4716 35.2368 -18.2726 5.22228 +3211 4 6.85856 6.3256 30.2181 -6.14256 4.86399 -3.96588 +3212 4 5.49729 5.53619 30.4137 -26.8093 16.306 -3.74387 +3213 6 38.1866 39.6 29.3849 -55.2477 -18.0227 -31.7741 +3214 4 37.4363 40.1798 29.0864 28.3626 1.3397 12.8196 +3215 4 37.8398 38.7214 29.0428 28.3274 26.4583 13.0641 +3216 6 52.5811 19.3636 5.41604 51.907 48.1011 -36.5249 +3217 4 52.4834 20.3242 5.17263 -20.1975 -32.0404 8.71389 +3218 4 53.4908 19.2453 4.99747 -31.6145 -20.6418 25.5541 +3219 6 18.3356 9.8205 21.0747 -17.6268 -29.6196 -17.636 +3220 4 17.8021 9.40634 20.3533 -1.88913 9.35392 27.897 +3221 4 19.0546 10.1733 20.5835 25.9839 20.5094 -7.72749 +3222 6 14.4924 41.1161 15.0432 10.1364 3.71296 -9.89663 +3223 4 15.2732 41.1462 15.6022 9.62288 -5.62086 4.10329 +3224 4 13.9031 41.7078 15.5102 -8.32301 1.75038 3.32266 +3225 6 35.9996 23.9069 26.7492 18.6837 -25.8156 -39.8793 +3226 4 35.9246 23.4421 27.5469 -8.45021 -0.659318 44.9575 +3227 4 36.3072 23.1381 26.2025 -8.08285 36.2837 5.17172 +3228 6 35.634 10.4286 26.2543 -16.0886 -36.8378 31.8954 +3229 4 36.0318 10.4196 25.4062 11.0324 6.64788 -31.8122 +3230 4 35.4344 9.46932 26.4326 4.10196 23.0818 -6.20158 +3231 6 45.3004 24.2842 20.2749 24.2383 10.4641 7.4623 +3232 4 45.3515 25.0535 19.6808 2.20237 -7.91345 -3.22769 +3233 4 44.5434 23.7522 20.0895 -20.4117 -5.11737 -13.922 +3234 6 15.8182 39.0515 24.2407 12.965 16.6456 0.954929 +3235 4 15.3741 39.8779 24.5544 7.5658 -17.411 -0.0196462 +3236 4 16.7724 39.3066 24.1247 -29.8541 -4.22386 6.92178 +3237 6 4.60659 25.9073 16.8122 1.83212 2.60998 -1.97709 +3238 4 5.31562 26.4095 17.2499 -5.00617 -6.2898 0.278133 +3239 4 3.79975 26.4302 16.9186 11.5163 2.87992 -0.585475 +3240 6 33.4767 9.9887 32.5701 -44.5277 -5.18869 -27.5725 +3241 4 34.322 10.1593 32.8843 54.6618 16.656 18.5178 +3242 4 33.0203 9.70843 33.3575 -8.70161 -12.0001 8.14623 +3243 6 22.9321 37.514 1.50284 -0.19108 -28.0604 17.8877 +3244 4 23.0149 38.2279 2.13297 1.92014 9.99004 7.14626 +3245 4 22.7552 36.7067 2.06858 1.19451 21.8657 -20.5647 +3246 6 39.1248 20.5474 25.4766 21.2332 -16.8391 26.0428 +3247 4 39.2186 21.3943 25.0643 2.22233 17.645 -5.02625 +3248 4 39.853 20.5019 26.1611 -16.83 0.667515 -19.8449 +3249 6 25.0699 25.071 37.6104 17.3941 16.9986 -26.7924 +3250 4 25.9994 25.4036 37.6322 -19.4928 -16.3283 1.07636 +3251 4 24.8822 24.8366 38.5108 -1.54859 -5.98321 18.8059 +3252 6 12.2108 35.7702 11.4211 -21.274 -0.450661 -24.3109 +3253 4 11.4942 36.1177 10.8268 17.2098 -2.57945 23.3101 +3254 4 12.7534 35.3113 10.7723 8.20233 4.40137 5.7707 +3255 6 42.0318 15.7212 20.1319 23.9789 -4.66934 -19.8056 +3256 4 42.573 15.4482 19.3354 -11.2719 11.6022 18.1956 +3257 4 42.3198 16.6222 20.3614 3.24172 -2.08619 -3.65764 +3258 6 53.203 25.4276 39.527 3.00787 -13.9161 6.63788 +3259 4 53.7641 25.8569 38.8977 9.18601 6.10619 -8.92001 +3260 4 52.4886 26.0297 39.6953 -12.4398 9.9207 3.51955 +3261 6 53.7999 21.7704 1.29423 13.4333 -6.07506 22.1965 +3262 4 54.6908 21.5389 0.969279 -9.57261 -3.1085 -1.99035 +3263 4 53.3016 22.2177 0.619486 -6.56312 6.61298 -22.2093 +3264 6 1.93757 22.4543 20.1748 -8.22485 -1.41006 19.3874 +3265 4 1.60089 23.2534 20.6505 8.04613 -19.7643 -7.74833 +3266 4 2.27012 21.8339 20.8623 2.42307 18.0741 -7.93574 +3267 6 41.1802 16.179 11.484 -8.24259 53.7733 14.6683 +3268 4 40.8475 15.3772 11.8508 -2.32532 -30.9762 7.10209 +3269 4 40.6167 16.8825 11.9353 16.6943 -22.3779 -21.294 +3270 6 17.1967 38.6113 9.60334 5.35995 -1.86267 -8.12923 +3271 4 17.7852 38.6361 10.3521 13.641 -0.452934 12.0217 +3272 4 16.3282 38.6029 9.98982 -18.6262 -0.708432 10.1602 +3273 6 33.1969 12.9538 38.5484 12.352 25.5713 -8.86638 +3274 4 33.6486 13.824 38.4674 -8.05485 -18.2555 -5.8969 +3275 4 33.0335 12.8861 39.4897 4.37007 -7.66636 -4.23751 +3276 6 24.7228 21.6957 39.9776 0.331302 -26.4697 -8.75647 +3277 4 24.5832 21.6143 39.0045 0.235774 0.581704 12.5709 +3278 4 25.2663 20.9218 40.2505 -4.0265 10.6546 -4.86064 +3279 6 13.577 15.5497 27.3411 27.7809 44.9786 27.5516 +3280 4 13.196 16.0821 28.0648 5.30872 -0.0493108 -10.0398 +3281 4 12.9031 14.935 27.2057 -29.8548 -39.4113 -11.0219 +3282 6 24.6863 18.7248 9.26482 -8.80414 -2.51529 14.0236 +3283 4 25.3563 19.2311 8.7609 -6.6335 -0.338001 12.1858 +3284 4 24.3761 19.0911 10.1338 17.243 1.91927 -22.7003 +3285 6 10.9743 8.21046 0.042398 -18.7759 13.8117 62.0104 +3286 4 10.3469 8.74796 0.639501 28.6352 -16.9877 -21.8389 +3287 4 11.7753 8.08291 0.592641 -4.28958 7.52309 -10.9298 +3288 6 15.7499 31.9609 31.3743 -17.6212 -20.5964 15.467 +3289 4 14.8817 31.9157 30.9761 -10.6343 5.00824 -7.09118 +3290 4 16.0827 32.8403 31.1978 10.1106 0.369155 -2.88897 +3291 6 20.3726 39.1695 21.6147 20.5981 -29.5513 41.0934 +3292 4 19.9726 38.3531 21.9994 -5.82675 23.323 -22.8284 +3293 4 21.1172 39.24 22.2595 -11.0324 14.4144 -20.0969 +3294 6 38.8594 19.5251 7.6091 -6.47304 13.0289 -25.1371 +3295 4 38.0017 19.0955 7.57416 -1.20877 -0.517864 1.64758 +3296 4 39.1744 19.3685 8.48411 8.18586 -10.9486 17.219 +3297 6 41.3695 29.7301 21.1465 -57.7285 -14.4296 34.1578 +3298 4 41.7832 29.6286 20.3251 24.9116 3.74799 -36.1007 +3299 4 41.9865 29.9579 21.8177 26.2541 9.18996 12.3917 +3300 6 50.7039 33.8333 22.0593 7.50244 -20.9835 17.6314 +3301 4 50.9654 32.9474 22.4123 -1.20949 24.7473 -8.4765 +3302 4 50.362 33.6446 21.1779 1.66119 1.27804 -3.63001 +3303 6 18.1671 11.1714 14.3658 -12.4278 -6.78987 13.7569 +3304 4 18.0724 11.2679 15.338 -0.312443 2.59996 -20.4321 +3305 4 19.115 11.0923 14.227 4.83391 -0.924272 -3.79066 +3306 6 48.5058 14.2689 15.2513 -36.7782 -21.7282 -18.3567 +3307 4 49.3677 14.5693 15.4148 44.1026 10.3807 8.68918 +3308 4 48.5803 13.5893 14.5426 -8.44167 10.5166 12.8885 +3309 6 32.9801 15.74 8.25484 19.5805 1.81858 6.30948 +3310 4 33.8151 15.5666 7.78828 -7.72407 0.576521 2.61047 +3311 4 33.2057 15.7253 9.21147 -5.47651 1.26655 -15.0149 +3312 6 42.9141 4.85593 18.7596 35.6338 16.8786 18.3104 +3313 4 43.0674 5.82698 18.891 -14.0493 -22.2454 -3.89051 +3314 4 43.7794 4.50634 19.0974 -23.5505 0.71427 -17.3058 +3315 6 10.488 23.7131 33.4436 27.6073 45.1219 -14.7699 +3316 4 10.638 24.6985 33.3892 -15.3766 -28.1208 6.63949 +3317 4 11.1638 23.4099 32.8243 -6.46894 -14.1785 5.09081 +3318 6 1.12582 20.0662 11.2775 2.81918 8.09367 56.8435 +3319 4 0.488344 19.3589 11.407 -2.14544 -6.99577 -20.9797 +3320 4 1.17571 20.424 12.22 2.69463 -2.11621 -44.733 +3321 6 1.50824 39.5346 14.3079 -5.25271 -28.0543 15.9462 +3322 4 0.868346 40.1487 14.6984 3.61457 -0.641003 -8.28938 +3323 4 1.2571 38.629 14.6571 12.5115 33.2201 -10.0417 +3324 6 8.3332 21.6069 14.1357 -16.8636 -16.8509 36.8071 +3325 4 8.17334 21.0976 14.9962 5.25323 23.3985 -29.627 +3326 4 7.56323 21.4407 13.5807 -3.95337 3.79773 -2.56685 +3327 6 7.16177 13.3249 38.2255 -6.34169 -18.8056 -1.32195 +3328 4 6.69256 13.0329 37.4043 9.76156 12.0715 20.3406 +3329 4 7.43529 14.2522 38.1581 -0.0118119 -11.8895 -14.491 +3330 6 46.6212 1.64167 18.6867 -0.0463537 -24.1078 41.7639 +3331 4 47.541 1.5611 18.992 -0.862753 9.16913 -10.8716 +3332 4 46.1606 1.36736 19.5239 4.43612 14.9978 -24.7224 +3333 6 4.08147 8.39338 14.788 26.1694 13.8207 2.32184 +3334 4 3.41636 8.28931 15.4347 -29.1417 0.0985708 23.0338 +3335 4 3.90156 7.69349 14.1818 -2.47935 -14.3959 -27.3016 +3336 6 47.5712 36.5372 17.8422 14.6219 44.3363 14.3039 +3337 4 47.1691 35.7037 17.6938 -6.70251 -40.3849 -9.96305 +3338 4 48.5299 36.4434 17.8412 5.708 -14.7801 -1.83759 +3339 6 48.7177 32.6293 3.61477 24.5557 -7.82504 -30.2396 +3340 4 49.3183 32.0587 3.09719 0.221751 18.4164 7.83871 +3341 4 48.4066 32.0299 4.25286 -21.3126 -17.4552 36.5328 +3342 6 26.8672 34.4113 15.184 7.18591 -12.831 -4.85448 +3343 4 27.1806 33.7337 15.7866 -5.2278 -3.11582 5.08403 +3344 4 27.3382 34.1395 14.3734 -5.71629 20.1707 6.74573 +3345 6 9.99603 27.3398 13.3337 -11.5184 -70.0362 -20.4383 +3346 4 9.96963 28.1856 12.9595 -3.0362 48.3298 -16.8459 +3347 4 9.789 26.7159 12.5598 12.8825 26.2078 29.4693 +3348 6 2.39106 26.8936 37.3456 -18.0299 -5.48602 7.48259 +3349 4 2.24944 26.7597 38.2955 12.6258 0.126767 -1.18485 +3350 4 3.33209 26.9598 37.1993 18.2818 -0.192027 1.55797 +3351 6 33.3384 17.273 36.7956 -4.69576 6.00605 30.6641 +3352 4 32.3777 17.4022 36.9421 6.35755 -1.66054 -12.3647 +3353 4 33.5147 17.1107 35.8745 -6.55426 -0.461729 -19.8283 +3354 6 10.6704 18.7989 9.29568 -2.62714 4.796 -4.28658 +3355 4 10.7729 18.8103 8.31395 -3.57004 -0.312677 18.1362 +3356 4 10.9356 19.679 9.6198 -4.15772 -1.10699 -11.1079 +3357 6 8.58029 27.4085 3.13543 -0.646896 -38.9365 14.7517 +3358 4 8.62134 27.4642 4.10772 -2.35878 18.0768 -8.00568 +3359 4 8.54298 26.4189 3.06204 -3.80038 30.3142 -4.62402 +3360 6 40.6121 33.9148 14.3433 -13.4775 28.2536 -12.7531 +3361 4 40.8898 33.2957 14.9932 8.13038 -23.145 12.8628 +3362 4 40.1237 34.5547 14.8716 -1.64981 1.12342 -7.13376 +3363 6 54.0126 16.7742 13.6402 -25.2384 12.1291 10.4483 +3364 4 54.0311 17.2666 12.8352 12.7766 5.78776 -30.0788 +3365 4 53.1083 16.9555 13.9311 3.38038 0.740926 17.4694 +3366 6 39.1613 38.4947 7.40674 -49.2832 -1.36929 38.9537 +3367 4 38.8094 38.4839 6.52049 1.87105 5.40513 -14.0728 +3368 4 38.3203 38.5292 7.99504 41.7155 2.10662 -28.5328 +3369 6 42.2152 33.6749 29.0207 -49.4578 14.7313 -27.4402 +3370 4 42.0113 34.6279 28.8262 15.7605 -21.0767 3.4048 +3371 4 41.3749 33.2313 28.6743 34.021 9.03137 24.2205 +3372 6 2.84529 0.06018 20.1342 1.75144 -0.125494 -5.27144 +3373 4 2.85876 0.453048 19.2323 -10.3946 -7.40064 8.89792 +3374 4 1.95714 41.5787 20.3005 13.5701 9.63706 -6.70109 +3375 6 24.9846 26.9367 24.435 4.97654 17.1262 30.4362 +3376 4 25.3707 26.0628 24.5275 -2.48626 -13.7157 -10.817 +3377 4 25.1946 27.3852 25.2847 -1.69157 -3.92554 -20.3381 +3378 6 13.6202 33.989 7.00835 -29.3159 10.7937 -13.6787 +3379 4 14.4707 33.6317 6.76766 5.19255 -3.31821 -12.8703 +3380 4 13.1262 34.2356 6.16936 24.7045 -4.21039 25.9053 +3381 6 17.6361 31.8361 3.38698 11.6752 63.8731 -26.646 +3382 4 17.3765 32.06 2.46015 3.81419 -8.12146 27.658 +3383 4 17.5414 30.922 3.45915 -17.4061 -53.1647 5.72422 +3384 6 31.114 29.8463 35.9142 20.4735 12.0385 -23.871 +3385 4 30.4046 29.6578 36.4892 -25.9224 -10.1565 23.4082 +3386 4 31.8798 29.3863 36.2596 4.49336 -0.641295 3.24883 +3387 6 31.4544 1.69927 1.93203 61.0942 61.1307 23.4408 +3388 4 30.847 1.03155 1.81447 -56.5376 -48.8621 -2.33617 +3389 4 31.1234 2.33851 2.60628 -4.67927 -17.7811 -18.4359 +3390 6 13.7206 9.35179 12.308 -20.4886 -14.5553 22.3614 +3391 4 13.8994 10.2254 12.0406 16.2488 33.284 -13.5816 +3392 4 13.1923 9.47724 13.1212 6.47756 -14.062 -7.29461 +3393 6 15.2915 15.1706 12.1407 -39.3514 -20.6771 -15.8676 +3394 4 14.288 15.1355 12.0691 34.6095 3.19954 13.2467 +3395 4 15.5721 14.5705 11.433 2.70369 1.94224 0.817449 +3396 6 44.9298 30.4448 13.0945 -83.0621 -13.8007 20.4391 +3397 4 45.2326 30.6692 13.9612 22.7288 5.76966 14.7184 +3398 4 45.5619 30.4921 12.4362 58.1466 4.79773 -38.6719 +3399 6 35.1494 37.6283 24.8564 -28.9971 -18.9514 34.2227 +3400 4 34.5453 38.351 25.1691 15.7809 -12.2194 -9.31628 +3401 4 34.8969 36.8477 25.46 15.2444 28.3361 -22.0595 +3402 6 43.9018 19.2999 12.9893 -4.23684 -28.8047 14.7243 +3403 4 43.7111 18.3276 12.9437 8.07938 21.0179 -2.3859 +3404 4 44.434 19.3703 13.8064 -8.2748 4.27416 -6.23054 +3405 6 14.1928 27.3824 16.8974 17.9721 24.801 -15.5057 +3406 4 13.3941 26.8971 17.049 -12.9837 -13.2841 -1.45311 +3407 4 14.075 27.8458 16.0392 0.928992 -14.2323 10.6565 +3408 6 5.07867 37.4759 15.7278 -19.2695 5.34987 61.0101 +3409 4 5.83402 37.4907 16.3496 5.41141 -1.20808 -8.02024 +3410 4 5.40595 37.3511 14.8725 27.2981 -13.142 -45.6678 +3411 6 35.4792 36.9736 33.2279 -33.1303 3.22524 14.2013 +3412 4 36.4062 37.0387 33.1707 43.394 6.70104 -6.41693 +3413 4 35.2647 37.5361 33.9926 -10.1497 -5.08286 -5.32556 +3414 6 6.63713 31.7122 32.9951 -15.6769 -13.4095 -29.903 +3415 4 7.30356 31.0631 32.7808 0.413821 -11.0386 -1.85208 +3416 4 7.01801 32.1732 33.7097 9.96672 21.2943 24.541 +3417 6 31.2686 20.2272 25.4717 1.63607 -11.2998 14.888 +3418 4 30.457 20.1188 26.0175 18.7046 8.55246 -6.40474 +3419 4 30.9671 20.3507 24.5747 -9.02709 8.2981 -6.80006 +3420 6 54.9594 26.0897 7.3541 -26.2324 -3.52234 4.1817 +3421 4 54.3149 26.536 6.76189 8.45344 -4.14623 9.81761 +3422 4 54.4064 25.6921 8.06559 9.60693 6.10548 -13.0393 +3423 6 17.8786 35.1581 24.3912 -48.4608 -31.2574 -23.2844 +3424 4 17.9034 34.576 25.1672 15.4891 12.513 -1.90366 +3425 4 17.14 34.695 23.8716 34.0055 23.8611 10.1154 +3426 6 49.1404 3.30993 19.753 -11.7437 -5.45724 -22.9314 +3427 4 48.7379 4.07245 20.162 -0.785462 12.6857 6.5087 +3428 4 49.8408 3.03849 20.3377 4.84054 -6.57183 8.59361 +3429 6 30.2791 35.6014 13.4902 -0.275976 1.62471 9.45881 +3430 4 29.4038 35.7322 13.1068 5.01216 -3.78726 -8.18413 +3431 4 30.1007 35.4484 14.4302 1.26073 -0.50544 -4.60872 +3432 6 43.3857 25.8788 41.6729 -28.3599 -13.2186 -4.43344 +3433 4 44.0236 25.6058 41.0289 13.0372 -2.28568 -15.7328 +3434 4 43.8192 26.4334 0.378509 18.4346 21.3926 23.5205 +3435 6 21.1033 23.1572 6.40534 -12.8895 6.60285 13.2505 +3436 4 21.2833 23.9599 6.94372 3.68538 -20.4677 -7.26612 +3437 4 21.2354 23.4378 5.50624 8.61756 6.39287 -19.4039 +3438 6 54.6209 21.1977 19.0953 -9.4905 16.5472 15.3455 +3439 4 0.355231 21.543 19.6762 -10.082 -5.94448 -19.8865 +3440 4 53.803 21.6498 19.4211 22.178 -8.62035 -3.94206 +3441 6 13.8696 38.9444 18.7589 -0.408574 -9.95072 10.686 +3442 4 13.5473 38.5195 19.5701 -4.79749 -3.34053 -10.6661 +3443 4 14.2783 39.7511 19.0654 -4.68159 17.5572 -2.41189 +3444 6 39.1837 2.73799 39.6933 -2.22487 -14.248 -19.2211 +3445 4 38.5048 2.18054 40.1045 3.50502 9.25929 9.72195 +3446 4 39.1752 2.3966 38.7788 -3.09486 7.3066 6.14055 +3447 6 43.2236 33.8218 8.83748 -23.7799 54.6507 -8.87946 +3448 4 43.1776 32.9835 9.22653 -2.14792 -45.6212 21.4927 +3449 4 42.4318 34.327 9.18683 27.5752 -12.6709 -4.85681 +3450 6 23.0768 16.6786 12.1043 19.2201 -8.5648 -22.0864 +3451 4 23.4688 16.2415 11.3109 -7.42341 7.06352 19.0042 +3452 4 22.1329 16.714 11.9048 -3.02708 6.60369 6.72608 +3453 6 40.7875 26.1445 36.3165 -31.0446 26.1707 15.63 +3454 4 40.1182 26.8831 36.2336 22.2291 -27.8038 4.66075 +3455 4 41.0346 25.9172 35.4285 12.0382 -0.567557 -16.236 +3456 6 15.1503 11.6728 19.298 -10.8743 -20.3409 15.6657 +3457 4 15.4707 12.2619 18.6272 13.0208 17.9076 -10.0848 +3458 4 15.518 11.9699 20.1418 -0.780585 5.28883 -4.88637 +3459 6 9.8485 29.8084 31.3808 31.6725 31.0987 -15.032 +3460 4 10.6075 30.172 31.8684 -9.75043 -12.6573 12.7307 +3461 4 9.98584 30.2945 30.5336 -20.1344 -22.7331 8.89086 +3462 6 2.12557 30.0341 25.264 -3.96851 -24.8252 -11.595 +3463 4 2.04755 29.1979 25.7442 2.8488 12.5065 4.07713 +3464 4 2.06741 29.7398 24.3306 5.27272 21.1251 20.17 +3465 6 49.0124 10.6515 7.04668 12.8278 -6.79775 19.6819 +3466 4 49.7765 10.456 7.62014 -4.12072 9.88663 -9.32692 +3467 4 48.4954 9.84699 7.16976 -12.5497 -3.43755 -7.74842 +3468 6 38.6385 34.4247 32.4851 8.7415 15.3068 2.26745 +3469 4 38.2449 35.2411 32.8392 7.79483 -2.42751 -9.0272 +3470 4 38.3877 33.7513 33.1114 -5.41613 -8.85245 5.88093 +3471 6 24.2967 24.7175 4.7858 -13.8074 20.2372 -8.25903 +3472 4 24.5879 23.8747 5.12331 8.49271 -10.4438 10.0312 +3473 4 24.0688 25.3355 5.52385 7.10746 -21.4288 -14.6014 +3474 6 44.0211 23.587 33.7713 -18.8641 -18.6234 -6.9532 +3475 4 43.6265 23.0569 33.047 -3.30007 6.44469 22.3225 +3476 4 44.7839 23.9213 33.3479 32.8249 22.1868 -7.88886 +3477 6 45.135 31.9539 26.6318 17.8742 -16.5206 -32.2352 +3478 4 44.6965 32.0125 27.458 -12.8805 4.46476 28.7394 +3479 4 45.0195 31.023 26.337 -1.34861 17.8758 10.4404 +3480 6 52.0545 6.36303 22.865 -1.87051 -30.929 -4.90791 +3481 4 51.4549 5.58836 23.0553 13.7734 29.2588 0.606927 +3482 4 51.4955 7.14596 22.8951 -3.5837 -3.73437 -5.39564 +3483 6 5.1124 17.7016 30.4663 -17.3022 -2.39818 -4.94531 +3484 4 5.57517 17.705 29.6436 5.33167 -14.42 -26.4334 +3485 4 5.6774 18.2653 30.9495 12.7188 16.8745 32.2475 +3486 6 48.5399 17.0091 6.52669 31.3107 25.6813 -22.3666 +3487 4 48.2466 16.108 6.56632 -4.44525 -18.5722 0.0807757 +3488 4 49.3123 17.0767 5.87973 -32.0368 -4.22047 21.2267 +3489 6 13.8017 31.3286 23.4652 -45.3568 -0.340859 23.461 +3490 4 14.0246 31.2001 24.3905 13.6426 -1.74144 -0.768444 +3491 4 14.5269 31.1963 22.8948 44.8358 -8.96568 -14.3918 +3492 6 28.4984 33.4231 26.025 30.2115 45.129 -4.70205 +3493 4 28.7629 32.7421 25.4284 0.749934 -18.6264 -12.7861 +3494 4 27.7356 33.1626 26.4825 -33.9251 -20.2776 22.3239 +3495 6 9.04101 22.9533 11.0101 4.17271 5.63899 8.67886 +3496 4 9.24243 22.776 10.0879 9.05926 -1.29962 -0.957415 +3497 4 9.84172 22.774 11.5341 -6.79246 0.647577 -9.3095 +3498 6 40.5624 4.0706 26.5792 43.7479 -58.1273 15.512 +3499 4 40.0377 4.03321 27.356 -14.6911 0.39925 31.4188 +3500 4 40.1771 4.74143 26.1095 -33.6389 57.2603 -43.6855 +3501 6 17.0606 37.9689 20.9328 24.9068 -2.83666 19.2437 +3502 4 17.7492 37.7057 21.5806 -0.23423 0.332892 -22.3637 +3503 4 16.3 37.9671 21.4825 -28.3901 -0.1668 6.57955 +3504 6 31.9758 6.36253 14.1925 -47.1359 -2.961 8.2158 +3505 4 31.6652 5.47044 14.4516 -0.57512 5.53961 -9.89258 +3506 4 32.9075 6.27907 14.242 33.1863 -3.34593 -3.73058 +3507 6 29.3613 34.9484 39.6522 -7.7658 6.78361 -10.4711 +3508 4 29.4154 34.7255 40.5688 2.48129 -3.65799 19.6008 +3509 4 28.4079 35.1232 39.5563 9.75382 -5.50564 -9.65046 +3510 6 22.5642 2.93231 32.1024 7.89654 -13.571 4.24933 +3511 4 23.152 3.60479 31.7467 -0.797152 8.5773 -0.128413 +3512 4 22.8746 2.10235 31.6905 -8.86372 14.3523 0.842504 +3513 6 51.7365 19.0888 24.8036 24.4352 10.6631 34.2631 +3514 4 52.2011 19.3182 25.6664 -22.8444 -5.9403 -33.5217 +3515 4 52.2256 19.5376 24.1035 -3.13425 5.18677 -1.50107 +3516 6 32.1309 13.661 24.2221 8.32979 -1.22201 -48.3483 +3517 4 32.1718 13.7834 25.1379 3.34806 7.10631 53.6256 +3518 4 31.2192 13.5434 23.9915 -25.9097 -1.66347 2.1781 +3519 6 9.49478 30.1756 28.7975 -1.02802 7.68553 8.51386 +3520 4 8.9614 29.4447 28.4635 3.13242 -3.87437 -3.11369 +3521 4 9.76139 30.7024 28.0341 -4.99689 -6.39164 -2.13333 +3522 6 31.3017 3.1328 24.0821 -2.56057 -13.3126 7.41322 +3523 4 30.8642 3.97896 23.9468 1.03353 -0.10231 -3.56587 +3524 4 32.1597 3.13825 23.6386 1.18226 10.803 -0.447916 +3525 6 2.13915 19.8328 36.4477 43.9795 26.8161 3.66972 +3526 4 3.0929 19.9274 36.115 -41.9598 -16.8793 8.64164 +3527 4 1.76662 18.9777 36.2517 -5.24508 -9.86619 -11.2286 +3528 6 36.9558 16.7701 14.0992 8.10199 -24.1685 -1.60142 +3529 4 37.0878 17.1202 14.9938 -3.44507 3.84646 -3.58016 +3530 4 37.3137 15.854 14.1066 -5.27996 15.1268 -1.92478 +3531 6 1.82451 11.1811 6.08431 4.75441 9.84221 -14.5701 +3532 4 1.68522 10.3449 6.52934 -2.64515 -5.74712 4.44833 +3533 4 1.45572 11.848 6.66197 -6.16769 2.71123 7.45582 +3534 6 43.1467 36.8536 25.2684 -4.34259 -25.2275 5.76074 +3535 4 42.489 36.6679 24.5813 -1.65581 9.08703 8.09798 +3536 4 42.9757 36.1566 25.9418 7.67001 18.3814 -10.5814 +3537 6 32.1358 5.54258 7.00813 -0.159667 5.03525 -3.02009 +3538 4 31.8447 4.70695 7.37259 1.76357 -8.94122 3.22744 +3539 4 31.6184 6.21523 7.45425 -7.92944 5.35442 3.67752 +3540 6 15.0738 21.498 41.5176 2.48253 -6.99424 4.64434 +3541 4 14.4083 21.441 0.286083 -5.89506 -4.91034 13.0846 +3542 4 14.6326 22.02 40.8608 1.523 7.8898 -22.5967 +3543 6 37.0299 36.0573 5.68999 -1.26402 -4.33671 -4.68257 +3544 4 36.8992 36.8706 5.1864 -9.04185 9.38437 4.54051 +3545 4 36.6368 36.1345 6.57983 4.68584 5.64444 -6.17041 +3546 6 39.6378 22.8733 0.344261 -10.4835 1.90991 -1.04201 +3547 4 39.8967 23.7127 41.8596 6.32696 2.65577 1.7872 +3548 4 39.7641 22.9598 1.30287 2.84221 -4.68177 2.22816 +3549 6 18.471 23.1695 5.24444 18.17 13.8994 5.32385 +3550 4 18.2426 24.0888 5.07969 -12.1406 8.45165 -11.681 +3551 4 19.3434 23.2774 5.65727 -5.17221 -14.3673 2.51868 +3552 6 34.4951 26.4012 0.415196 -24.2262 -21.8504 23.5375 +3553 4 33.9567 27.1096 0.873351 15.2264 -25.8266 -5.88921 +3554 4 34.3584 25.5285 0.919462 6.17703 40.7497 -12.3351 +3555 6 28.1538 26.089 40.6186 -44.0465 -12.7539 23.8091 +3556 4 29.0676 25.9468 40.8623 9.74545 0.451611 8.45277 +3557 4 27.5517 25.6856 41.3354 31.2048 15.0133 -28.9196 +3558 6 41.7541 4.40312 30.2348 -21.1804 7.97019 15.7848 +3559 4 42.5951 3.9554 30.1474 10.5948 -6.90465 6.49815 +3560 4 41.6197 4.66064 31.1807 9.39609 -4.15263 -13.0838 +3561 6 4.45746 8.30422 29.123 17.0584 8.0822 12.8675 +3562 4 3.72424 8.78851 28.7689 -20.5564 0.917363 -10.5697 +3563 4 4.90241 9.00738 29.631 2.39094 -12.8625 -4.67793 +3564 6 12.9051 9.61174 32.1485 9.54391 19.7002 1.20842 +3565 4 12.5238 8.90328 31.6499 -4.6135 -18.7028 0.941221 +3566 4 13.4507 9.29961 32.8815 -5.77341 -6.01915 -0.606497 +3567 6 48.6524 16.2364 1.45279 -39.5117 19.3379 22.5337 +3568 4 49.5656 16.3395 1.57323 44.82 -2.42546 -4.76282 +3569 4 48.322 16.6449 2.29127 -2.06599 -18.2277 -23.678 +3570 6 26.4391 39.9942 21.1964 -5.73 55.7886 4.05886 +3571 4 27.1886 40.6225 21.0926 -13.7426 -7.13397 8.25982 +3572 4 26.7825 39.1793 20.9147 12.833 -38.7313 -7.54244 +3573 6 35.8074 4.09236 9.03492 -45.4698 -15.3304 -15.5709 +3574 4 35.5046 4.67089 8.30824 2.24043 1.80806 6.22839 +3575 4 34.9768 3.81452 9.52186 26.5657 10.3238 -8.47709 +3576 6 52.6895 3.55751 27.8666 50.2867 -19.9176 -34.5196 +3577 4 53.5586 3.5996 28.3549 -33.5645 -3.53647 -1.9565 +3578 4 53.0019 3.22463 26.9489 -24.4009 21.759 36.9675 +3579 6 48.3192 26.6913 27.3954 13.1896 -37.7442 -6.45526 +3580 4 48.9722 25.929 27.4853 -22.116 34.446 0.770506 +3581 4 48.7243 27.4862 27.7371 6.43066 9.80699 11.7315 +3582 6 24.507 4.96042 18.7259 -17.59 -10.4057 14.9036 +3583 4 24.0519 4.20246 19.1729 14.2279 16.3534 -10.8515 +3584 4 23.9406 5.7442 18.8517 8.31711 -9.56192 -0.149656 +3585 6 24.0493 12.473 28.7688 20.4432 11.2466 2.34496 +3586 4 23.2439 12.9627 28.9427 -11.3477 -3.77152 -2.6943 +3587 4 23.8404 11.6087 28.4204 -6.74951 -3.90152 -5.01594 +3588 6 40.1637 27.7353 40.8087 -33.5791 -9.4694 0.953173 +3589 4 40.5641 26.9832 41.236 1.78301 2.25495 0.260865 +3590 4 39.2218 27.4214 40.7917 21.7476 20.7917 -9.34619 +3591 6 11.9335 13.5538 26.9488 -1.21599 4.57236 -11.9259 +3592 4 11.0364 13.8177 27.1576 -7.67129 -6.9102 2.53909 +3593 4 12.2164 12.9501 27.6309 4.70555 -13.4351 6.55277 +3594 6 52.1924 29.5424 41.3942 11.5626 -24.8936 -19.0003 +3595 4 51.8104 30.1965 0.050158 4.44506 23.3375 14.6186 +3596 4 53.1351 29.3771 41.6391 -10.5303 1.44862 4.74126 +3597 6 17.4882 19.0285 39.1853 -8.07927 32.7478 0.0743051 +3598 4 17.5012 19.6463 39.9647 -0.891206 -23.8414 -20.0908 +3599 4 17.261 19.5796 38.3923 8.05332 -16.519 21.1694 +3600 6 46.2326 27.6801 33.704 6.45393 -8.86534 7.23017 +3601 4 46.097 28.3723 33.048 -4.6559 5.79968 -1.93617 +3602 4 45.5979 27.7746 34.4233 -3.33861 16.4707 5.34235 +3603 6 35.8364 29.5448 5.62541 9.64171 -18.9009 -6.27826 +3604 4 35.5566 29.3199 4.72548 3.62776 14.0584 -3.56087 +3605 4 35.3944 30.354 5.86953 -6.57081 16.5188 2.47276 +3606 6 47.2881 25.7744 30.172 -6.62968 25.0044 -44.0548 +3607 4 48.1218 25.8653 29.6696 -5.94381 -7.49802 14.0131 +3608 4 46.6882 26.3745 29.6449 8.85802 -15.1094 17.4745 +3609 6 51.3842 12.359 20.0239 24.4626 17.3052 -5.31346 +3610 4 50.8707 12.833 19.3583 -10.0057 -7.98386 3.51527 +3611 4 50.8448 11.6564 20.3722 -11.0446 -8.70835 7.6307 +3612 6 41.976 18.3776 28.9581 25.2971 -7.26912 -18.3725 +3613 4 42.7018 17.9973 28.405 -17.3573 7.64094 3.96866 +3614 4 42.4517 18.9921 29.5246 -2.74764 -0.293653 0.793262 +3615 6 53.6043 6.48027 7.50524 -23.0657 -32.6432 -30.9738 +3616 4 53.1601 5.59498 7.33399 18.2827 28.6912 7.08019 +3617 4 53.6632 6.576 8.44633 9.6706 -3.87944 16.2616 +3618 6 9.90786 10.6094 26.7582 6.17728 8.73826 28.1859 +3619 4 10.299 10.3755 27.6331 -6.59671 -6.24018 -20.7073 +3620 4 9.65116 11.5299 26.9247 0.732239 -5.98194 -12.944 +3621 6 9.31054 39.3957 29.7756 40.7644 23.7808 19.8799 +3622 4 10.1982 39.3563 30.2561 -34.3316 0.809436 -14.8313 +3623 4 8.83679 40.1565 30.1832 5.55001 -15.1294 -12.8037 +3624 6 33.4099 4.77839 0.03236 -17.6047 -18.7695 14.8321 +3625 4 33.6454 5.53147 41.4176 15.8926 12.9618 -7.52592 +3626 4 34.0969 4.09847 41.8942 -0.186489 10.0102 -3.03658 +3627 6 35.7116 10.6673 34.2398 36.7653 -21.2814 -15.2586 +3628 4 35.2554 10.867 35.0388 -18.8422 0.575424 27.4634 +3629 4 36.4577 10.0619 34.4978 -21.6361 17.9445 -5.28322 +3630 6 15.2039 17.4016 19.1867 13.7018 -34.0248 -48.7675 +3631 4 15.5709 16.9982 18.3093 -23.7907 16.5473 43.0322 +3632 4 14.2523 17.472 19.021 -2.02403 4.48523 -0.714523 +3633 6 17.4757 37.6682 15.4227 -5.7624 0.927264 51.2416 +3634 4 17.0409 37.838 16.3209 3.67045 -5.85113 -35.7653 +3635 4 18.3529 37.3927 15.7202 1.879 4.38305 -13.464 +3636 6 26.263 8.20496 21.7043 -12.9193 13.0258 38.8746 +3637 4 26.2935 8.46487 22.6678 13.4631 -3.74504 -28.0146 +3638 4 25.3122 8.09558 21.5911 -4.90698 -1.77416 -12.6216 +3639 6 0.327844 9.89683 15.4174 -28.4002 -4.57955 -27.8061 +3640 4 1.20252 9.6859 15.1701 33.2298 -8.84956 3.25601 +3641 4 54.8213 9.3498 14.7471 -0.695723 21.8052 24.8209 +3642 6 13.451 40.6616 9.29616 -29.1589 -29.1317 3.11657 +3643 4 12.531 40.2581 9.2528 27.9164 27.237 1.6895 +3644 4 13.9533 39.998 9.7876 1.76749 3.89663 -1.50565 +3645 6 49.5605 25.9144 33.0102 6.77982 -23.7672 54.8124 +3646 4 50.0733 25.5846 33.8473 -25.1648 19.9091 -52.5505 +3647 4 48.6275 25.6453 33.15 14.5478 0.915879 -9.46863 +3648 6 37.0796 40.0419 26.4359 -26.9931 13.9721 12.3681 +3649 4 36.1882 39.5442 26.6099 42.8933 36.2545 -2.50818 +3650 4 37.051 41.026 26.6764 -12.8506 -44.3362 -9.04112 +3651 6 47.9916 17.8545 12.1553 -7.21137 29.6324 -37.7219 +3652 4 47.6652 18.6843 11.7058 6.42171 -29.0319 9.52509 +3653 4 47.7397 17.941 13.056 -8.12129 -2.80141 29.1943 +3654 6 27.9724 29.0571 34.165 6.45289 -21.5611 -2.40729 +3655 4 28.8948 28.8211 34.3683 -10.3018 1.8492 -2.91154 +3656 4 27.944 30.0064 34.1676 -0.713497 24.9251 0.854011 +3657 6 33.997 2.77014 13.2231 -35.3168 39.3397 6.14274 +3658 4 33.7592 2.40426 14.0871 -4.38792 -6.80294 -4.34532 +3659 4 34.7545 2.32608 12.931 40.4814 -27.3629 -5.76242 +3660 6 28.4454 36.033 11.4537 -30.811 -5.98685 22.1865 +3661 4 27.9997 35.3658 10.9161 0.521783 -1.73573 4.3727 +3662 4 28.9676 36.474 10.8303 31.7187 19.1344 -28.008 +3663 6 36.1836 11.3675 28.8638 -20.2526 -8.96451 -46.9053 +3664 4 35.201 11.3136 28.8426 17.393 5.15327 13.3727 +3665 4 36.3619 11.2493 27.8855 5.85658 3.26624 29.9739 +3666 6 24.7946 39.4802 16.9069 19.0937 3.96627 -8.4872 +3667 4 24.3751 40.345 16.9988 -5.97342 -3.52606 0.908874 +3668 4 24.9466 39.3518 15.9585 -10.9099 3.48913 2.54936 +3669 6 49.9504 8.05659 22.8451 -38.4139 -9.47108 -34.4931 +3670 4 49.9375 7.9588 23.7925 -16.1787 -3.75115 16.4902 +3671 4 49.0231 7.8493 22.4633 39.8101 3.17892 24.2331 +3672 6 52.1004 19.3469 10.2236 -1.12118 28.0811 1.24376 +3673 4 51.6057 19.3908 9.40186 -4.74475 -17.9853 -5.36861 +3674 4 52.3066 20.3081 10.2872 8.90847 -30.6944 7.30622 +3675 6 24.8344 15.8907 6.13046 -10.5287 3.62194 6.20212 +3676 4 24.2343 16.3288 6.78807 10.5214 -9.32926 -18.7028 +3677 4 24.4584 16.0701 5.24836 4.34413 4.47582 9.48796 +3678 6 49.3142 23.7074 8.6354 12.7826 -64.5552 32.8663 +3679 4 49.2168 22.9153 9.25307 13.1077 36.9849 -24.4484 +3680 4 48.4233 23.9587 8.46247 -20.5325 16.4959 -12.9251 +3681 6 0.200228 10.6387 32.1899 4.57462 9.08702 -50.3173 +3682 4 1.12405 10.3631 32.1441 4.84637 -6.06001 20.7538 +3683 4 54.8206 10.7585 33.0477 -1.25869 -8.0958 33.7963 +3684 6 12.5866 32.9145 13.2359 -45.84 -1.33101 12.3773 +3685 4 11.7384 33.4448 13.1799 26.1773 -16.8128 -1.90055 +3686 4 13.2757 33.4614 12.9111 20.4647 17.7705 -9.07485 +3687 6 21.729 32.5695 14.1172 -9.28791 -20.3928 5.37861 +3688 4 21.166 33.3661 14.1597 2.78901 -9.86158 3.94413 +3689 4 21.3002 31.8069 14.587 7.27427 31.5827 -10.8786 +3690 6 48.1522 34.8482 27.3304 1.15431 -17.6089 -40.5894 +3691 4 47.5385 35.1725 27.9994 -6.04073 -2.93057 -0.479876 +3692 4 47.6796 34.4132 26.5454 8.99615 21.2578 35.6726 +3693 6 45.6357 31.2393 36.095 -40.8957 20.4658 25.2026 +3694 4 45.8476 31.9489 35.493 1.2761 6.76392 -14.6383 +3695 4 44.8829 31.5945 36.6582 19.8537 -10.4851 -18.3708 +3696 6 46.2846 0.316369 14.3569 -23.6541 -29.5796 11.0344 +3697 4 46.2347 1.24867 14.1822 6.12226 14.592 -0.646978 +3698 4 47.172 41.8876 14.3137 22.6277 5.76419 -11.0491 +3699 6 14.3437 18.9821 40.2104 -25.2995 -33.3041 -15.9392 +3700 4 14.4094 19.2869 39.3238 4.54227 2.45102 -23.4893 +3701 4 14.593 19.7098 40.7196 18.3341 34.8836 33.2243 +3702 6 14.5595 1.13832 10.2184 21.0915 11.237 11.4523 +3703 4 15.4791 1.15983 9.85648 -24.9846 -0.242798 0.374642 +3704 4 14.0639 0.416501 9.81608 3.47586 -8.24251 -5.69878 +3705 6 34.4238 40.9137 13.0059 -4.24882 -26.6665 -25.0696 +3706 4 34.0907 40.4301 12.2099 6.6876 25.2293 12.1693 +3707 4 34.3655 40.2093 13.6737 -1.45879 20.9599 -0.365544 +3708 6 42.1372 25.6317 33.9946 32.9644 -29.1434 -4.32848 +3709 4 41.7256 25.3671 33.1599 -4.34041 1.82357 5.58197 +3710 4 42.8775 24.9612 34.1276 -26.6125 21.4128 -4.76888 +3711 6 29.2041 22.5904 40.0709 -12.2401 -3.24737 -11.2113 +3712 4 28.5312 23.0545 39.5673 2.40343 6.95864 -1.48823 +3713 4 29.0042 22.7646 40.9807 1.44808 0.219743 17.343 +3714 6 44.8039 18.6198 1.5029 3.83338 16.5679 14.3409 +3715 4 44.9659 19.0204 2.39019 -3.90529 -17.866 -14.3425 +3716 4 44.0478 19.1074 1.16429 2.25905 3.06151 -3.31671 +3717 6 4.48486 10.8191 23.9456 -47.6019 -35.9978 3.19751 +3718 4 5.13394 11.3869 23.6113 33.8353 31.137 -11.4748 +3719 4 4.52769 10.7271 24.8961 2.68899 9.9192 5.78369 +3720 6 6.46393 23.0191 29.0034 23.802 4.69353 23.6764 +3721 4 7.14249 23.0161 29.7285 -18.6834 17.7038 -21.9419 +3722 4 6.49076 22.0968 28.8008 -10.0115 -22.5628 -12.4771 +3723 6 39.7912 25.1434 32.5739 17.5205 -18.6836 -60.5647 +3724 4 39.6128 25.3468 33.4485 -16.6712 22.7672 53.7369 +3725 4 39.6667 25.9357 32.0325 -1.3786 -0.359445 4.68486 +3726 6 40.844 21.4875 8.87812 10.6958 -1.16061 -24.4784 +3727 4 40.753 21.3778 7.91779 -6.86728 3.07162 8.13114 +3728 4 41.3272 20.6946 9.13123 4.7165 -6.17308 11.2164 +3729 6 0.614957 1.42802 12.9561 35.282 30.4207 -35.1483 +3730 4 54.8795 1.90166 12.5287 -4.84596 -15.7095 11.3484 +3731 4 0.325279 0.716474 13.4972 -22.2917 -16.9379 18.816 +3732 6 32.6687 29.7155 23.4821 0.172893 -14.8348 21.3896 +3733 4 32.2937 28.8037 23.5347 8.27316 18.2339 -7.75927 +3734 4 32.5776 29.9928 22.5742 -5.86304 -0.191283 -15.879 +3735 6 12.5314 37.1515 20.4729 45.6241 64.5302 32.6184 +3736 4 13.0675 37.1561 21.3077 -14.1528 -0.638655 -18.1117 +3737 4 12.0966 36.3476 20.454 -27.4762 -63.6198 -6.10217 +3738 6 13.8924 14.5151 24.69 -3.15938 -4.02598 20.115 +3739 4 13.491 15.2498 24.2338 -4.44789 9.69439 -9.34194 +3740 4 14.0279 14.8194 25.6039 -0.281954 0.872924 -9.09093 +3741 6 17.5021 27.063 26.4741 18.9499 -7.93165 -17.7551 +3742 4 17.3645 27.9616 26.0981 5.20292 -20.1733 2.46217 +3743 4 18.105 26.551 25.8503 -19.0729 23.9469 15.4793 +3744 6 54.4877 9.53021 26.3477 -5.78247 7.96784 25.4661 +3745 4 54.0512 10.3733 26.628 8.34027 -15.1138 -9.49744 +3746 4 54.8923 9.139 27.1544 -8.60221 9.32804 -13.3813 +3747 6 33.6807 21.5011 24.9225 20.8165 12.7411 -37.5161 +3748 4 33.6447 21.5342 23.9109 -0.857654 -11.0597 35.2787 +3749 4 32.8481 21.1477 25.2212 -19.5227 -6.82771 5.56304 +3750 6 22.1475 35.2701 2.885 -1.57378 -2.18642 30.1771 +3751 4 22.1887 34.3602 2.5781 3.09514 -3.18559 -9.19859 +3752 4 22.1072 35.1817 3.87164 0.12039 0.813186 -18.6146 +3753 6 45.3027 5.41438 15.6133 24.4211 -32.124 17.7203 +3754 4 45.2073 5.06649 16.5292 -4.89018 16.6426 -14.7318 +3755 4 44.541 5.92364 15.3615 -17.3903 4.72304 -1.03383 +3756 6 5.67534 7.5869 16.981 -5.47297 6.8358 -20.2139 +3757 4 5.25896 7.81046 16.1225 6.35918 -0.232773 12.9215 +3758 4 6.51331 8.07041 16.9918 4.7107 -6.94883 2.60141 +3759 6 34.576 39.0992 27.2053 24.5889 13.5844 -33.9491 +3760 4 34.3093 38.4547 27.8221 -16.0328 -19.2876 29.327 +3761 4 34.0621 39.904 27.3046 -7.96056 4.01318 13.6593 +3762 6 32.7541 33.6107 34.2903 -12.2088 11.6467 -22.6039 +3763 4 32.1008 34.0277 33.6489 27.9813 -13.6615 23.3944 +3764 4 32.6574 34.0489 35.1447 -11.8345 -0.637226 -0.957772 +3765 6 31.0088 41.2052 32.3952 -16.5884 -4.13679 -5.08533 +3766 4 30.2065 41.1942 32.9317 -1.71273 -1.00977 6.80252 +3767 4 30.9738 0.147898 31.9828 5.47722 15.337 -6.15299 +3768 6 7.65161 1.58314 27.1492 34.9115 -9.04616 -23.8477 +3769 4 8.49581 1.43905 26.61 -35.9655 -7.00487 18.1392 +3770 4 7.51162 2.51613 27.0476 -4.48076 16.5289 1.77021 +3771 6 0.884173 22.0999 37.8474 19.5684 -22.3581 -15.9684 +3772 4 1.29289 21.3236 37.3582 -15.3878 24.821 16.8607 +3773 4 1.19208 22.8872 37.3739 -1.97361 -3.14502 -0.467946 +3774 6 7.41204 11.1157 19.2314 -38.1481 -15.0427 -1.85178 +3775 4 7.53858 12.0593 19.2468 12.5581 17.6457 8.19935 +3776 4 8.2604 10.6916 19.3015 17.9889 5.14781 -4.65775 +3777 6 43.7858 12.4956 37.3097 0.920036 9.73958 -3.1733 +3778 4 43.9612 12.5094 36.3537 -0.436236 -2.21513 6.60981 +3779 4 44.6264 12.7918 37.692 -0.443403 -7.75914 -0.361508 +3780 6 29.0868 33.5248 36.1867 6.33086 18.8505 -43.8567 +3781 4 29.87 33.99 35.8176 -18.9328 -5.41066 10.4629 +3782 4 29.4633 33.0358 36.8874 15.3521 -14.5291 31.9885 +3783 6 14.802 4.59099 3.93345 20.4849 22.8827 12.2406 +3784 4 14.3757 4.0439 3.27797 -5.14737 -6.71868 -8.73832 +3785 4 15.6594 4.91612 3.57855 -16.4986 -14.1515 -5.85747 +3786 6 39.0551 6.39795 6.38864 -31.6963 1.09254 42.8867 +3787 4 39.3692 7.21691 6.04781 17.6944 18.3081 -17.2196 +3788 4 39.3538 5.69048 5.84285 10.6785 -8.50098 -20.4551 +3789 6 22.2123 37.9977 40.776 -14.7699 -23.2033 -28.4168 +3790 4 22.4586 38.8695 40.5021 9.68098 25.7962 -2.3277 +3791 4 22.4791 37.9118 41.6765 7.85923 -2.07179 26.9545 +3792 6 4.44877 23.2867 6.14309 -1.92846 -21.7963 14.7751 +3793 4 3.85981 23.8785 6.59389 -8.34079 22.3777 -5.30491 +3794 4 4.15148 22.4458 6.53602 18.5324 -1.87236 -10.5169 +3795 6 12.4298 23.7885 9.24819 15.5635 1.24594 19.7483 +3796 4 11.6299 23.5219 8.81427 -22.2296 0.449899 -3.14002 +3797 4 12.2156 24.1823 10.1208 2.55292 -1.37139 -18.7826 +3798 6 46.4922 15.2589 16.9667 3.22745 3.94864 2.0367 +3799 4 47.1791 14.9867 16.3488 -1.59454 -10.7105 -10.6804 +3800 4 46.8221 16.1143 17.2497 1.89409 2.98219 12.0057 +3801 6 34.1117 27.1644 19.7797 24.4736 -11.2812 21.2279 +3802 4 34.8774 26.5238 19.7962 -19.6491 14.1094 -6.20677 +3803 4 34.0324 27.4806 20.6991 -2.21978 -4.312 -16.0235 +3804 6 46.9479 13.2121 35.1109 14.7829 18.0264 15.8687 +3805 4 47.3232 14.0654 34.8894 8.1348 3.75559 6.81177 +3806 4 46.5576 12.9943 34.2929 -17.7211 -19.0679 -23.646 +3807 6 50.5883 18.7922 12.536 -4.97475 -8.40096 -18.6689 +3808 4 49.7377 18.4417 12.2063 9.85466 0.19572 8.20723 +3809 4 51.2037 18.6585 11.7837 -7.44169 10.1395 9.07394 +3810 6 32.4871 12.6357 31.9554 3.75694 -28.5712 -45.9238 +3811 4 32.607 11.6542 31.8864 5.47128 21.8321 9.55763 +3812 4 32.4011 12.8494 32.8587 -4.02679 2.16968 41.7104 +3813 6 6.20502 19.6778 10.0162 1.71901 21.9334 16.0314 +3814 4 6.41826 20.2441 9.25697 6.75258 -1.0862 1.44387 +3815 4 6.08129 20.3112 10.7738 2.93045 -16.0896 -19.0741 +3816 6 21.5254 21.5246 2.44441 10.1652 3.23891 -24.6245 +3817 4 21.7373 21.5014 1.49425 -3.90993 5.22039 4.49463 +3818 4 22.0841 20.8004 2.76184 -10.1442 1.98878 12.5692 +3819 6 38.3901 23.0895 17.1987 11.9637 -29.1373 -23.0023 +3820 4 38.7115 23.1739 16.2902 2.30233 23.4463 5.8212 +3821 4 38.6091 22.1461 17.2941 -10.4226 8.48715 23.8901 +3822 6 29.6992 24.9636 22.2212 38.6917 -37.4999 -9.7813 +3823 4 30.2244 25.0209 22.9989 19.9484 -5.9881 25.7874 +3824 4 29.0295 25.5321 22.4534 -63.588 46.0104 6.14599 +3825 6 30.2959 21.4331 37.7732 -36.6703 24.7369 -1.55525 +3826 4 30.3833 21.3736 36.7928 -5.6984 1.01251 23.2154 +3827 4 29.3642 21.7906 38.031 44.833 -25.8334 -23.6526 +3828 6 11.8968 11.712 16.3062 -52.2626 -16.509 -42.1992 +3829 4 11.3487 12.2512 16.8737 -4.04714 4.99791 6.8918 +3830 4 11.2749 11.5458 15.4981 35.5887 6.11969 38.645 +3831 6 5.69762 16.9728 10.4703 1.06122 -0.586779 5.28994 +3832 4 4.99177 17.1708 11.0979 -1.96678 -11.04 -5.71485 +3833 4 5.85288 17.8179 10.0528 3.40155 4.97172 -3.96907 +3834 6 41.7052 34.1635 35.8846 2.77529 22.9845 38.2917 +3835 4 41.9958 35.0267 36.2582 -8.6238 -19.1969 -5.00662 +3836 4 41.6615 34.3005 34.9574 -2.57818 -0.630621 -34.674 +3837 6 33.7668 1.16041 30.1021 -7.73366 -5.3538 60.0773 +3838 4 32.8437 1.27671 30.3431 -6.56672 10.3256 -18.6068 +3839 4 34.0939 1.04339 31.0463 15.1522 -1.22783 -40.312 +3840 6 50.3589 18.6227 36.9888 29.2523 22.0538 -2.88024 +3841 4 50.1022 18.8636 37.8788 -6.7252 3.81489 7.59342 +3842 4 49.7597 17.9698 36.6907 -30.5426 -29.286 -11.4073 +3843 6 24.6818 24.2557 40.239 -30.3362 18.6852 9.52233 +3844 4 23.7683 24.4347 40.5809 21.1328 -2.57181 -5.50386 +3845 4 24.791 23.3075 40.3447 2.5826 -1.14956 -5.51696 +3846 6 37.3025 22.0306 23.2304 -1.24857 -1.55203 26.5345 +3847 4 37.0034 21.8174 24.1364 -3.77965 7.42086 -11.5868 +3848 4 37.7677 21.2337 22.9852 8.84969 -1.31238 -13.2672 +3849 6 48.4163 40.4951 28.9695 -6.68628 11.813 -16.9736 +3850 4 49.0084 41.2243 28.7075 -10.6266 -4.31108 -6.63999 +3851 4 47.6767 40.479 28.3098 12.2088 -0.876211 11.6705 +3852 6 24.8524 8.74511 16.566 -5.47802 -1.24744 16.6444 +3853 4 25.3154 9.32041 17.1898 2.58295 -0.80606 -7.28092 +3854 4 25.3735 7.93816 16.4942 1.51819 -5.71343 -7.74972 +3855 6 19.2312 23.0154 32.4581 7.29767 -10.2486 -2.08042 +3856 4 18.4295 23.4489 32.1618 3.75321 4.57429 -6.83594 +3857 4 18.9208 22.4103 33.1253 1.01223 -4.21105 8.69504 +3858 6 3.33807 21.6805 22.4551 -46.3933 -7.60477 16.0737 +3859 4 2.65604 22.1286 23.0335 23.3212 -20.9163 -13.0515 +3860 4 4.02869 22.318 22.3903 27.1551 13.0827 -5.07429 +3861 6 10.2258 20.3371 12.829 -8.54969 -20.6717 -8.68144 +3862 4 9.56384 20.8338 13.3253 4.28314 2.73019 -3.94148 +3863 4 9.70568 19.6401 12.367 8.3544 15.6282 9.01344 +3864 6 9.53393 0.668964 25.3385 8.23748 17.1946 -9.08311 +3865 4 10.3992 0.538209 25.8183 -20.1327 16.9559 -17.4439 +3866 4 9.57635 1.38514 24.6117 12.9812 -33.3008 29.4344 +3867 6 10.6624 40.712 9.64369 -16.6479 -8.09828 -30.6343 +3868 4 10.6692 41.3905 10.303 1.51816 10.4523 18.0663 +3869 4 9.97599 41.0031 8.99599 12.0328 -9.66263 16.6565 +3870 6 46.359 25.2248 32.6769 -14.7838 37.2607 37.796 +3871 4 46.1367 26.0735 33.2154 13.6855 -48.6436 -31.9122 +3872 4 46.6282 25.5659 31.8216 4.36769 -3.83668 -6.22015 +3873 6 38.9431 3.2028 23.1016 18.0409 -17.6687 24.963 +3874 4 38.0396 3.32435 22.9005 -28.138 13.963 -19.732 +3875 4 38.8834 2.64883 23.9052 13.1186 5.8311 -6.82495 +3876 6 33.334 23.6417 36.8871 -1.6197 -14.346 14.9842 +3877 4 32.7695 23.6175 37.7211 18.6046 10.6207 -30.6843 +3878 4 33.5528 24.5621 36.6745 -4.59115 1.63353 1.59233 +3879 6 51.9355 33.3272 25.435 24.4931 61.1901 -39.0042 +3880 4 51.4286 33.1494 26.1943 -20.5556 -13.8295 37.3068 +3881 4 51.9313 34.3506 25.3627 -2.33157 -52.0679 -5.38276 +3882 6 32.1777 25.0215 33.1655 -4.40266 21.2191 -9.05445 +3883 4 32.7541 25.8194 33.0841 -10.7751 -17.7804 3.95932 +3884 4 31.2703 25.3891 33.0319 13.5135 -10.8842 0.697404 +3885 6 51.2858 27.7149 39.5023 -29.438 -28.7732 26.1015 +3886 4 51.6029 27.7352 38.6212 16.0201 9.86215 -30.6452 +3887 4 51.6337 28.456 39.976 12.6328 17.4546 7.30145 +3888 6 34.2938 28.319 17.2582 8.1769 -6.30709 4.0332 +3889 4 33.5147 28.7567 16.9609 -27.2201 13.5182 -7.119 +3890 4 34.2215 28.3851 18.2119 5.48963 -10.3892 10.8325 +3891 6 36.9125 8.03614 37.8626 31.6258 41.6511 37.5008 +3892 4 37.1772 8.64874 37.1722 -6.23292 -16.4311 -22.0997 +3893 4 37.3691 8.52088 38.6203 -30.9712 -36.3395 -15.9768 +3894 6 34.8794 19.4073 6.12479 12.5531 6.66298 1.29528 +3895 4 34.0931 18.8687 6.15723 -9.84615 -2.81902 0.903663 +3896 4 34.5874 20.3343 6.07707 7.75337 -1.04832 -3.72421 +3897 6 52.9388 9.46792 7.82791 49.0384 32.8563 -49.3294 +3898 4 52.8922 10.1625 7.06425 -6.6048 -31.3865 41.9454 +3899 4 52.145 9.34409 8.30569 -37.6802 7.72308 13.142 +3900 6 36.3078 5.4787 38.9756 -59.3492 -35.3574 -23.3076 +3901 4 36.7604 5.44249 39.7856 34.2456 7.44664 27.0781 +3902 4 36.4713 6.28646 38.5283 19.3627 32.146 -13.2298 +3903 6 10.0102 14.4476 13.47 7.45507 32.9986 11.9551 +3904 4 10.2267 15.3574 13.7991 -6.33005 -21.0964 -5.42394 +3905 4 9.26267 14.5991 12.8847 -7.70629 -5.78085 -0.713961 +3906 6 17.2158 24.3617 39.7859 1.82925 -26.4802 17.5225 +3907 4 16.9252 25.2477 39.6578 -10.2532 23.1813 -8.78866 +3908 4 16.8659 24.1409 40.6742 12.3143 -2.49802 -8.33055 +3909 6 49.0708 32.5605 7.76617 4.98775 -19.9892 12.4117 +3910 4 48.2488 33.0406 7.85919 -4.66971 4.38963 1.84033 +3911 4 49.5854 32.9586 7.08254 9.03816 10.9607 -18.1455 +3912 6 44.8772 24.3958 5.47001 55.4245 15.4507 -4.26518 +3913 4 44.8128 24.5742 6.41303 -16.1158 -0.171295 7.10823 +3914 4 44.0866 23.9971 5.17679 -42.0653 -18.1716 -4.3799 +3915 6 37.3106 29.1913 32.8596 13.2918 -7.82588 25.4298 +3916 4 36.7195 29.353 33.61 10.148 2.43022 -0.346483 +3917 4 36.7915 29.3572 32.1043 -27.5405 3.64351 -29.7293 +3918 6 0.903259 24.8209 21.2384 21.1637 23.8586 -12.5999 +3919 4 1.07153 25.1845 20.3306 -6.36458 -4.90686 24.2304 +3920 4 1.48599 25.3539 21.839 -15.2813 -16.355 -7.82064 +3921 6 53.0335 2.20305 13.0061 -8.76459 0.917863 -30.1717 +3922 4 52.7178 1.83592 13.8181 -1.16689 -4.66991 20.3458 +3923 4 53.3973 3.07458 13.1779 4.70755 1.41814 13.7418 +3924 6 24.3073 33.9788 13.9425 26.9643 -19.8352 3.53447 +3925 4 23.8166 33.1535 14.1304 2.48225 11.7572 -2.64876 +3926 4 25.2622 33.8278 14.204 -36.1259 9.29052 -3.07765 +3927 6 40.931 19.3008 0.314297 -22.2267 40.7784 4.53314 +3928 4 41.073 18.3876 0.266006 15.5735 -49.6404 -1.39225 +3929 4 41.7685 19.7545 0.415523 11.1161 2.19254 -0.550631 +3930 6 38.3131 32.0321 21.5909 -11.558 27.6654 -12.3629 +3931 4 37.7152 31.3901 21.181 3.54948 -0.803384 -4.61225 +3932 4 38.0485 32.9451 21.2634 6.02672 -33.9485 15.0266 +3933 6 42.3093 34.9988 16.9782 -31.0886 21.3467 -4.04435 +3934 4 41.4322 34.9872 17.4259 23.1708 5.16072 -1.2535 +3935 4 42.7209 34.172 17.1456 10.0707 -23.8474 2.85212 +3936 6 19.5555 24.3301 21.9337 4.81064 -45.312 41.7565 +3937 4 19.0503 23.5208 22.2695 18.6897 32.4519 -16.5084 +3938 4 18.9494 24.7901 21.383 -21.2783 9.24005 -16.3011 +3939 6 21.0765 3.08453 14.9497 18.8565 6.62045 0.482113 +3940 4 21.9827 3.42458 15.1377 -20.4059 -2.71097 -2.70114 +3941 4 21.0593 2.94323 13.9894 -7.00518 -5.35814 1.95693 +3942 6 16.4422 12.1477 28.531 -0.750899 4.00912 3.87665 +3943 4 16.9503 12.6102 29.2147 -1.62139 -0.392447 -5.94721 +3944 4 15.8278 12.7952 28.1633 1.40376 -4.03425 1.22377 +3945 6 29.5501 4.7113 21.752 31.6763 -19.7408 -11.7502 +3946 4 29.7575 3.81476 21.3864 -8.62397 20.1371 9.94028 +3947 4 28.6767 4.97136 21.4837 -14.307 1.15287 -5.34284 +3948 6 47.4015 12.0887 13.4082 -20.234 -20.0739 19.2385 +3949 4 46.7896 12.1748 12.658 5.24956 2.33261 8.08179 +3950 4 46.8763 11.6307 14.143 25.8489 23.9178 -32.3489 +3951 6 26.4368 0.034911 5.58657 -64.7941 -10.5287 17.818 +3952 4 25.4579 0.386547 5.64311 57.7785 -5.53424 -8.5606 +3953 4 26.2825 41.0177 5.90114 11.1228 18.2746 -10.9356 +3954 6 20.8239 34.8091 41.3451 3.02448 22.7042 23.7072 +3955 4 20.8848 35.7307 41.7064 -1.83719 -23.2001 -12.5561 +3956 4 21.5135 34.3024 41.8142 -0.435548 5.34794 -5.15218 +3957 6 12.6914 17.4806 1.38079 -1.22179 11.8948 19.0955 +3958 4 12.6924 17.2614 2.32235 1.20892 0.120609 -3.36771 +3959 4 12.6119 16.652 0.923905 -0.609755 -13.5185 -16.0456 +3960 6 30.0783 10.198 8.41195 2.12134 -1.25171 -25.3141 +3961 4 29.3533 10.7626 8.0964 5.01977 -3.23694 0.534487 +3962 4 29.9182 10.0601 9.33268 -3.94599 -2.47727 24.1034 +3963 6 36.3506 5.44781 23.9083 -0.549638 14.3818 20.7021 +3964 4 36.0156 6.32048 23.6328 6.62881 -2.58855 0.476976 +3965 4 37.0027 5.63115 24.6267 -8.58297 -8.41851 -13.9364 +3966 6 34.0301 39.9488 19.4964 -23.0399 -20.8249 18.5921 +3967 4 34.456 39.4415 20.2152 6.93565 15.6495 -14.2212 +3968 4 34.6348 40.5483 19.0534 11.5364 2.12704 2.14354 +3969 6 25.0981 29.0133 17.0022 63.4673 53.603 -24.6749 +3970 4 24.4066 28.4545 17.2066 -49.3728 -47.1307 14.2315 +3971 4 24.9323 29.3693 16.11 -4.01222 -10.2038 10.3173 +3972 6 28.4991 21.3215 6.5284 30.3134 51.3135 12.4116 +3973 4 28.073 21.8131 5.82363 -12.0684 -17.0718 -17.6117 +3974 4 29.0439 22.0969 6.88435 -18.1485 -38.7813 5.23359 +3975 6 18.6639 26.1486 0.434559 17.278 41.4043 -10.2832 +3976 4 18.2934 25.3073 0.618971 -26.4426 -25.2614 5.85754 +3977 4 18.1648 26.8598 0.892557 2.28699 -17.4047 3.2853 +3978 6 10.9881 29.7025 15.4563 -76.0882 18.6105 19.9394 +3979 4 11.66 29.3744 14.945 58.6215 -25.2203 -34.7363 +3980 4 11.3165 30.0451 16.2682 18.0847 5.23212 20.5617 +3981 6 33.4842 3.75768 10.5858 0.636803 10.5574 28.6939 +3982 4 33.4734 3.50079 11.5612 -0.522502 1.02567 -36.066 +3983 4 33.5593 4.73652 10.6 -0.068286 -14.4363 0.33475 +3984 6 12.2823 28.8038 23.0281 11.3775 -6.29424 6.84391 +3985 4 12.7596 29.6284 22.9364 3.04418 8.52871 -1.54448 +3986 4 11.6562 28.9633 23.7417 -11.9653 1.92572 -6.97409 +3987 6 13.0879 10.2853 41.0171 -47.2786 6.02767 7.69694 +3988 4 13.8008 10.0588 41.5617 38.8858 -12.6991 24.323 +3989 4 13.445 10.533 40.1929 12.5253 9.31307 -31.237 +3990 6 45.8279 29.9763 22.3517 -19.0059 -47.3471 -0.794771 +3991 4 46.3385 30.6632 22.7121 22.9496 35.5749 11.5915 +3992 4 46.1736 29.1608 22.8005 -10.4716 15.4455 -15.9284 +3993 6 41.5587 12.1258 14.79 16.8952 2.46742 -19.497 +3994 4 40.8127 12.0778 15.3866 -8.88903 2.06539 11.4921 +3995 4 41.9001 13.025 14.8368 0.886253 5.83282 4.44761 +3996 6 18.1774 7.21532 24.17 -10.7079 71.0597 15.5191 +3997 4 17.3895 7.85304 24.2309 32.278 -29.8877 -8.26822 +3998 4 17.8432 6.3671 24.0218 -31.5603 -50.1252 -1.23769 +3999 6 1.46617 28.3087 7.5822 17.4051 32.8243 -18.4272 +4000 4 0.972435 27.5241 7.77639 -23.983 -7.56132 -3.64975 +4001 4 0.919057 29.0368 7.16413 8.17263 -22.6878 11.3207 +4002 6 11.3257 12.3178 24.0505 6.50608 36.5044 21.7543 +4003 4 11.787 12.9182 24.6663 -15.142 9.53056 -9.69028 +4004 4 11.7144 11.5384 24.3755 9.90684 -45.3393 2.97811 +4005 6 17.9727 40.4585 24.4268 -2.1753 13.4943 43.6914 +4006 4 18.2079 40.9973 23.706 15.3173 17.1897 -35.5256 +4007 4 17.8423 41.1404 25.131 2.16294 -27.9915 -10.5346 +4008 6 25.5983 7.44259 34.0136 19.3716 5.77393 -21.6373 +4009 4 25.8935 7.97324 33.2232 -7.88236 -13.8451 20.6491 +4010 4 24.6626 7.5793 34.1612 -12.3217 5.75259 0.6842 +4011 6 16.9533 36.3934 7.79695 -14.7733 -58.972 -15.2131 +4012 4 16.1509 35.7821 7.92089 32.5681 38.8119 0.0631702 +4013 4 16.873 37.2333 8.21975 -10.866 19.0251 14.3825 +4014 6 12.4478 39.1676 36.8063 -58.2746 -19.2691 -7.14825 +4015 4 13.2621 39.5728 37.0444 24.763 -2.90148 -1.94315 +4016 4 12.5678 38.2718 36.42 14.2903 21.5885 11.3364 +4017 6 23.4428 1.91286 37.7232 -9.22102 6.32267 -24.8838 +4018 4 22.7837 1.60923 37.0782 3.11058 2.78987 13.6287 +4019 4 23.6923 2.7833 37.361 6.97145 -2.92816 9.87668 +4020 6 26.6131 34.8527 39.0629 -0.358317 22.46 -5.08852 +4021 4 25.9211 35.0251 39.7209 4.63868 -0.642547 -8.45736 +4022 4 26.6245 35.623 38.4346 -11.8568 -25.3624 13.8384 +4023 6 44.7506 35.5772 23.1679 10.7298 -18.8811 -26.4233 +4024 4 44.6498 36.2622 23.8111 -7.39072 22.4611 10.5052 +4025 4 44.899 35.9413 22.2637 -2.27133 -5.1907 16.9936 +4026 6 34.6136 35.4178 26.71 -15.9342 1.46423 13.2724 +4027 4 33.7739 35.201 27.1682 15.3038 9.13482 -13.5788 +4028 4 35.2424 35.4667 27.4557 -1.55634 5.60609 -12.3698 +4029 6 12.4253 29.8367 9.37257 6.8074 7.71813 14.8361 +4030 4 12.5954 30.1793 10.279 -1.64518 -2.79843 -17.3301 +4031 4 11.9756 30.5342 8.87466 -2.55144 0.413422 5.70549 +4032 6 46.4578 41.3781 16.9525 -1.71223 -15.9012 -6.63524 +4033 4 46.309 0.164546 17.5847 2.66821 13.6546 8.2853 +4034 4 46.3887 41.8168 16.0911 -0.805017 -2.71613 2.08401 +4035 6 39.1753 31.0467 24.0118 -3.10819 6.08124 -21.6124 +4036 4 39.1065 31.2708 23.0301 -7.23524 -5.82233 36.9271 +4037 4 38.2867 31.0608 24.4123 9.52041 3.88051 -10.8568 +4038 6 40.5402 9.7597 28.9847 14.8037 -28.2595 -25.194 +4039 4 40.7176 8.78836 28.9335 -4.00485 22.4893 3.39032 +4040 4 39.9733 9.89103 29.7293 -9.65138 5.58475 19.0645 +4041 6 33.5593 11.9211 22.729 -1.15717 -3.69298 36.7387 +4042 4 33.4631 12.1387 21.8005 -14.8881 8.7456 -3.74916 +4043 4 32.9393 12.4796 23.2922 26.8098 -15.4098 -27.756 +4044 6 29.0159 38.7519 2.46278 27.6721 -15.5988 -40.3681 +4045 4 29.1586 39.6546 2.1748 2.74048 3.67355 2.54153 +4046 4 28.5501 38.8453 3.26351 -22.211 -0.421087 25.3577 +4047 6 51.2833 6.14739 28.3043 6.24107 -1.78447 -16.8419 +4048 4 51.6927 5.30788 28.0231 -4.79213 3.01935 13.8596 +4049 4 51.5671 6.73798 27.5888 -1.89698 -2.53529 10.4249 +4050 6 34.1064 16.6123 14.042 -37.0155 -16.4066 -7.07731 +4051 4 33.9904 17.5439 13.9588 -10.6946 23.5239 -0.125603 +4052 4 35.0244 16.4872 14.0391 48.662 -2.86898 -0.118382 +4053 6 34.4321 40.0645 7.48859 13.9518 5.57425 38.6209 +4054 4 34.6497 40.8416 6.93548 -15.3832 -25.9537 -5.407 +4055 4 34.0868 39.3056 7.01264 2.49953 7.17747 -18.8692 +4056 6 42.5297 22.9808 4.38266 2.56422 12.7755 -29.8183 +4057 4 42.7079 23.1404 3.43503 2.07895 -8.20356 9.72626 +4058 4 41.6007 23.2438 4.43282 3.68115 -1.88729 13.9368 +4059 6 1.41725 11.7089 10.583 40.9585 72.4956 7.82458 +4060 4 2.29602 11.7947 10.1149 -31.3121 -19.1762 2.07637 +4061 4 1.32217 12.6809 10.8959 0.250133 -47.8987 -12.0904 +4062 6 10.0222 17.1523 40.4009 -13.9984 -42.4532 23.0969 +4063 4 9.09922 16.7881 40.4362 25.3227 17.9847 -3.64852 +4064 4 10.5566 16.4623 40.9043 -11.7978 28.1532 -20.1855 +4065 6 26.3773 1.16785 23.7951 0.897687 17.1036 -20.4546 +4066 4 26.2949 1.59753 22.8926 6.72339 -10.2637 31.134 +4067 4 26.8106 1.83522 24.3632 0.404944 -5.36666 -8.232 +4068 6 4.47728 16.2319 39.0174 38.9165 -19.7518 -18.3291 +4069 4 4.60126 15.8787 38.0926 -3.95383 11.2541 23.7603 +4070 4 5.37849 16.1152 39.4714 -36.6531 9.54225 -13.0705 +4071 6 24.3645 39.8454 14.0862 11.6717 18.512 -7.42816 +4072 4 24.2179 40.7168 13.6655 -1.51261 -13.0973 5.973 +4073 4 25.144 39.5095 13.6466 2.38152 -7.3908 -1.6645 +4074 6 19.9724 19.004 10.1294 8.87966 -14.5095 2.71373 +4075 4 19.0999 19.3915 10.2782 -1.93643 -3.06257 7.63815 +4076 4 20.1403 18.2899 10.8137 -9.49435 28.7308 -18.8504 +4077 6 45.2455 15.0555 25.2985 9.44949 25.5865 29.6023 +4078 4 44.5225 15.6147 25.6238 -9.11717 -2.3226 -13.4673 +4079 4 44.9162 14.4027 24.6993 -17.0358 -18.2103 -14.0354 +4080 6 47.6513 32.9537 29.9733 -3.02769 -8.48031 15.1317 +4081 4 47.7848 32.4488 30.7976 5.01558 10.2706 -8.76515 +4082 4 46.6987 33.0693 29.9097 -5.02316 -0.316015 -4.02449 +4083 6 9.31033 14.1561 35.6305 -9.15199 13.4931 14.7277 +4084 4 10.2186 13.9515 35.3646 1.69372 -1.68405 10.862 +4085 4 9.25805 14.5533 36.5394 11.2175 -11.577 -22.5615 +4086 6 0.560208 28.7354 32.128 -23.2584 38.0618 20.8665 +4087 4 0.439761 29.1616 31.2639 2.79308 -8.58991 0.800302 +4088 4 0.67028 27.8063 31.9961 10.5465 -16.7679 -9.91325 +4089 6 26.1282 14.1993 40.8411 59.6454 -38.6249 5.43898 +4090 4 26.432 13.4524 41.4491 -20.3805 31.5142 -12.0858 +4091 4 25.201 14.2926 40.8644 -35.6636 2.31432 7.08225 +4092 6 38.0409 1.72795 37.3461 -15.986 9.3487 3.27435 +4093 4 38.337 1.77003 36.4219 -6.4212 0.733726 8.60438 +4094 4 37.1869 2.24333 37.3721 25.3175 -16.9011 -0.126137 +4095 6 43.391 21.0055 0.385428 11.1435 51.3868 10.1231 +4096 4 43.3728 21.9356 0.739051 -22.7765 -27.5137 5.23027 +4097 4 44.2566 21.1078 41.893 4.66373 -25.0138 -11.6612 +4098 6 29.7339 12.3948 17.084 15.7249 11.0657 13.1734 +4099 4 30.3928 12.9555 17.5239 -4.04604 16.1495 -27.1654 +4100 4 29.6387 11.801 17.8166 -19.321 -23.8097 4.84602 +4101 6 21.0831 10.9976 35.6454 20.8751 25.9078 26.8503 +4102 4 20.9144 11.9356 35.5 -2.5465 -0.914036 2.40284 +4103 4 20.6111 10.5739 34.9651 -17.7649 -25.2648 -31.6786 +4104 6 24.3635 22.1336 17.0651 -49.7832 5.03398 -16.9936 +4105 4 24.7447 22.8357 16.5516 14.0354 11.6369 -2.31656 +4106 4 25.0369 21.6158 17.4366 35.7007 -17.2122 18.4164 +4107 6 44.2543 9.63808 6.15039 20.313 -11.2139 14.5913 +4108 4 44.7688 9.46356 5.36091 -1.47318 -0.699349 -10.0319 +4109 4 43.371 9.9028 5.92157 -14.9065 6.10764 -5.2575 +4110 6 40.8032 2.87739 6.28666 -13.1289 22.479 10.901 +4111 4 40.3272 3.11809 7.09229 2.74106 -9.45257 -1.64817 +4112 4 40.5645 3.60702 5.69531 8.12536 -6.41414 -12.3146 +4113 6 23.4888 29.7691 25.1996 -20.8577 -7.3866 7.78845 +4114 4 23.0356 30.0691 24.4173 -11.1707 -5.96106 -7.76576 +4115 4 24.1981 30.3761 25.2406 38.2449 14.7306 0.541559 +4116 6 45.2336 20.6129 7.48752 -14.5833 -17.9538 -3.88696 +4117 4 44.4222 20.5961 6.94177 10.1673 3.83834 -0.615812 +4118 4 45.4226 19.6724 7.65027 4.1577 11.2609 0.378107 +4119 6 44.1804 26.5848 16.646 -7.77871 8.0927 60.0057 +4120 4 44.4497 26.5291 15.7549 9.82788 -17.3929 -39.3829 +4121 4 43.995 25.6977 17.0036 0.668911 -2.30329 -14.751 +4122 6 23.5902 27.0659 18.0913 -39.7013 -11.93 7.95298 +4123 4 23.083 26.2674 17.8176 19.208 11.4009 -9.44785 +4124 4 22.9184 27.4761 18.6801 25.6051 0.00742342 -8.40738 +4125 6 45.1467 16.0991 8.91755 -25.3782 -1.90264 -8.59791 +4126 4 44.1891 15.9425 8.7462 16.1978 6.4454 1.17339 +4127 4 45.2138 16.0078 9.87006 7.52298 -2.6657 10.2407 +4128 6 39.0203 15.1531 5.23259 28.6956 12.0263 -26.8074 +4129 4 39.7994 15.5772 4.7964 -10.087 -12.1112 6.39319 +4130 4 38.3368 15.7917 5.08662 -19.5574 10.6606 0.980846 +4131 6 40.468 4.77411 20.0927 -27.3359 -4.798 12.1592 +4132 4 41.2634 4.72652 19.6 29.6653 -1.38796 -18.2664 +4133 4 40.7147 5.23292 20.8909 -0.487482 4.30709 11.6637 +4134 6 35.8395 28.4372 39.9091 -50.8572 -25.335 -8.14583 +4135 4 35.0416 27.8127 39.7761 37.8149 25.8469 12.2999 +4136 4 36.4241 28.1912 39.1903 12.774 -11.5781 0.139918 +4137 6 26.5706 3.57143 2.67715 -46.9093 11.529 -12.2012 +4138 4 26.01 3.47498 1.86726 21.0232 -0.263485 19.1529 +4139 4 25.9795 4.13239 3.25499 25.5536 -16.3527 -3.3314 +4140 6 2.96374 21.6426 17.6806 -14.2306 -5.51577 -4.68338 +4141 4 2.93927 22.2072 18.4518 0.989431 6.72084 9.51867 +4142 4 3.70489 21.9005 17.1296 5.59779 10.8847 0.849605 +4143 6 12.8869 25.0552 25.9401 15.4127 26.4598 -14.83 +4144 4 13.2774 25.9118 25.6194 -5.06291 -21.1213 8.866 +4145 4 12.0842 24.9634 25.4247 -11.7493 -3.09829 -2.0396 +4146 6 41.5869 20.6707 14.1801 -22.4147 -6.05744 0.611169 +4147 4 42.2929 20.1295 13.8255 12.8925 2.43785 -7.39699 +4148 4 41.9118 21.5622 14.3536 8.70683 -8.7017 2.36606 +4149 6 1.26372 39.5934 11.5416 -2.31472 -23.2994 -17.666 +4150 4 1.60499 38.7626 11.0579 -12.721 36.8399 30.164 +4151 4 1.30151 39.4907 12.5143 8.15813 -4.07121 -11.1907 +4152 6 16.0274 39.0089 34.0759 -23.376 3.35378 -54.2756 +4153 4 15.5279 38.2654 33.6809 12.2329 5.59336 21.1278 +4154 4 15.9645 39.6681 33.3256 8.94624 -4.65522 31.8649 +4155 6 20.5749 7.01511 25.5545 -9.93748 22.9073 -1.77669 +4156 4 20.7998 7.9126 25.2373 7.69672 -13.5438 0.480138 +4157 4 19.6147 7.02086 25.4453 1.79337 -5.45304 -5.32881 +4158 6 45.1903 25.5946 39.1745 -26.3826 2.10768 23.1727 +4159 4 45.9078 26.0337 38.7511 23.0136 15.7961 -19.2282 +4160 4 45.315 24.6755 38.9972 4.74877 -22.0383 -3.82349 +4161 6 19.9254 40.1108 28.2935 0.936604 13.13 -6.83142 +4162 4 19.0415 40.3022 27.9603 -1.00367 -13.9734 -0.221352 +4163 4 20.1058 40.9072 28.8104 6.81084 -8.28794 7.10232 +4164 6 26.5025 14.2024 27.3816 7.55525 -11.5245 -39.7478 +4165 4 25.5661 14.1885 27.2241 -23.3405 -0.187867 -1.3667 +4166 4 26.5864 14.6167 28.2174 4.05242 7.69107 36.9512 +4167 6 51.349 25.9455 3.44193 13.1564 1.83251 -14.1309 +4168 4 51.0731 25.276 4.04973 -8.84751 -13.2679 15.0063 +4169 4 51.8098 25.4164 2.75525 -2.9574 19.5765 2.79729 +4170 6 20.1579 26.1269 2.66057 8.08543 -14.232 12.5138 +4171 4 20.4198 25.2285 2.95049 1.99012 13.1431 -7.88687 +4172 4 19.9848 26.1042 1.70984 -1.68704 0.137755 2.48294 +4173 6 3.12857 11.9594 27.2244 18.8731 20.7243 14.7894 +4174 4 2.60719 12.6622 26.8077 5.30838 -2.59233 -3.81502 +4175 4 3.76928 12.4285 27.8301 -19.9135 -11.7573 -12.7739 +4176 6 30.1745 26.3671 4.00755 44.117 -33.7612 35.926 +4177 4 30.7719 25.91 3.40695 8.20711 -11.5121 5.52432 +4178 4 29.6741 26.8182 3.4039 -49.0538 48.0497 -39.0484 +4179 6 19.309 20.6617 30.5327 -6.17305 20.3286 19.7257 +4180 4 19.3357 21.5037 31.0044 -16.2324 -1.53368 2.5841 +4181 4 20.215 20.6027 30.2783 24.1248 -10.9268 -16.9107 +4182 6 13.5428 36.2605 0.333332 15.0011 -10.6689 28.2547 +4183 4 13.9636 37.1467 0.274336 -13.564 -9.3403 -16.0521 +4184 4 12.8146 36.0991 41.6409 -4.77188 14.7057 -15.3617 +4185 6 13.69 21.7667 35.9665 -20.2473 -15.4187 -13.4538 +4186 4 13.4364 21.3658 35.099 7.7487 10.4825 13.8843 +4187 4 14.5406 22.1631 35.8296 17.4857 6.37333 -3.13554 +4188 6 39.4374 1.76506 25.3393 -36.4427 -7.29022 -10.5984 +4189 4 39.9364 2.34528 25.9215 16.7605 -3.08023 1.72977 +4190 4 39.8192 0.8892 25.1573 19.013 15.1682 11.727 +4191 6 18.3049 6.14326 35.8392 -10.8025 -19.5812 3.54688 +4192 4 18.125 5.32611 36.3393 4.50778 0.182671 -16.8727 +4193 4 18.2664 6.78418 36.55 10.3297 13.4079 -7.40032 +4194 6 2.50698 24.635 10.1008 2.82606 57.1639 14.1456 +4195 4 3.34783 24.2504 10.0645 38.9609 -42.7111 -6.9151 +4196 4 2.85647 25.509 10.4424 -34.1939 -15.4438 -5.60802 +4197 6 35.8245 9.94707 1.36321 12.392 22.5458 6.51215 +4198 4 36.2598 10.3662 0.602857 -1.03193 -1.33218 7.37913 +4199 4 36.14 10.4815 2.15194 -8.91958 -29.9524 -28.0328 +4200 6 29.0093 17.9332 41.5934 -7.9582 -11.0366 0.585828 +4201 4 28.5465 17.2289 41.1281 -16.7755 -3.81322 9.83818 +4202 4 29.6221 18.1453 40.9114 24.9254 25.1746 -10.164 +4203 6 46.0106 27.0842 25.8657 -15.8538 -10.6571 1.20957 +4204 4 46.7573 26.8966 26.4316 13.3887 1.52966 8.34957 +4205 4 45.3967 26.3449 26.0537 1.02353 6.85943 -7.5889 +4206 6 28.1115 10.6516 35.9124 -31.4415 -9.81676 -35.067 +4207 4 27.3321 11.0804 35.4953 10.9044 -14.8673 0.927998 +4208 4 28.4149 11.3158 36.4913 19.5717 24.3857 28.0975 +4209 6 25.9462 20.1874 24.7713 21.0981 19.7274 8.06252 +4210 4 26.7479 20.7296 24.6265 -12.3387 -9.71047 -3.27099 +4211 4 25.8934 20.1715 25.7373 -11.4252 -1.9185 3.65337 +4212 6 32.2315 30.2636 10.2038 46.2181 -42.2335 3.06511 +4213 4 32.6954 30.7903 9.55855 -13.4496 21.2522 -10.6663 +4214 4 32.9512 29.5744 10.3289 -28.7668 14.232 9.31608 +4215 6 5.05112 34.4033 23.8133 19.5013 -14.7597 17.0713 +4216 4 5.8904 34.9145 23.8209 -18.4686 -4.57798 -7.44977 +4217 4 4.4328 34.8283 23.2333 -4.78059 12.4432 -11.9709 +4218 6 29.6287 34.9421 23.1129 15.2461 20.4143 1.29823 +4219 4 30.2662 35.203 23.7945 -9.70178 1.77141 2.28452 +4220 4 29.7307 34.0083 23.0447 -4.13429 -24.1479 2.03513 +4221 6 52.1909 25.2296 36.2512 2.86438 -10.6824 22.6831 +4222 4 51.9483 25.3775 37.2028 5.23419 -4.07811 -26.4725 +4223 4 52.3343 24.2634 36.1804 -4.32722 6.81431 1.64545 +4224 6 6.96184 41.26 14.9825 2.80521 -5.8094 -40.534 +4225 4 7.04984 41.0874 15.8994 5.94782 -9.0625 22.8431 +4226 4 7.58542 40.6644 14.4953 -8.6815 16.2518 18.3581 +4227 6 27.6618 39.1341 4.65497 -15.321 -2.42325 19.5764 +4228 4 26.8583 38.6531 4.9607 13.8024 7.31782 -7.34321 +4229 4 28.2878 39.16 5.39008 -5.06496 -7.53921 2.22048 +4230 6 44.4448 15.8874 30.3939 -2.31018 0.103575 -22.4191 +4231 4 43.6353 16.4379 30.2788 15.6665 -12.4266 1.42045 +4232 4 44.7559 15.574 29.5018 -16.8402 11.4423 19.721 +4233 6 27.2939 38.1254 13.0955 15.3768 -40.6351 2.35664 +4234 4 27.6299 37.3572 12.5713 -6.06373 15.2601 5.99839 +4235 4 27.2975 37.7701 14.0147 -10.0522 11.5876 -10.9657 +4236 6 26.6773 32.9794 36.8294 -32.6396 -25.4624 12.1292 +4237 4 27.3491 33.5429 36.5103 30.2383 22.5556 -9.12925 +4238 4 26.1784 33.4868 37.4729 2.39424 7.35453 7.52648 +4239 6 26.3034 28.2003 31.7109 71.1077 16.3155 0.283388 +4240 4 26.8193 28.3341 30.863 -27.929 -6.55919 23.3278 +4241 4 26.9955 28.4613 32.4053 -35.143 -9.24619 -18.2719 +4242 6 49.2075 35.7729 23.3324 -21.4287 30.6035 9.89313 +4243 4 49.7648 36.3085 23.9054 5.92838 -6.84736 -0.0129328 +4244 4 49.7125 35.0813 22.9401 23.5965 -22.3057 -11.2126 +4245 6 44.2384 15.3735 33.5479 -0.546939 -12.4927 -0.897907 +4246 4 44.8734 15.133 32.8785 13.8917 -2.34347 -2.72297 +4247 4 43.5631 15.8174 33.0372 -7.79828 14.1806 -0.143619 +4248 6 16.6415 35.2629 14.0425 -13.711 -12.7272 -22.5016 +4249 4 16.8779 36.1297 14.3524 2.35153 17.3801 14.4176 +4250 4 15.7232 35.3535 13.695 18.4875 1.24889 7.88518 +4251 6 45.2979 21.4768 12.0753 -61.6802 -17.7786 9.36854 +4252 4 45.9745 21.1118 11.5746 47.2025 -15.5682 -31.9287 +4253 4 44.6407 20.7302 12.0307 13.4445 30.1014 15.4365 +4254 6 51.647 5.33893 20.0992 17.3373 6.85256 40.4731 +4255 4 51.8423 5.82757 20.9547 -12.0569 -16.4938 -26.4666 +4256 4 50.8652 5.75336 19.736 -8.70547 10.2387 -6.49138 +4257 6 22.616 27.3068 0.953729 -12.5585 5.72419 11.7926 +4258 4 21.9912 27.9206 1.39427 2.62886 -13.0847 -9.82719 +4259 4 22.9744 27.8285 0.229956 6.91293 3.08187 -2.36887 +4260 6 46.8924 12.1405 22.3241 28.0037 10.4006 6.07885 +4261 4 46.5361 12.6234 21.5839 -13.5229 3.11861 -11.9828 +4262 4 46.2058 11.655 22.757 -25.8682 -9.85748 8.02404 +4263 6 33.7577 5.61095 25.2306 8.81298 -10.6825 9.18366 +4264 4 34.4045 5.06092 24.7535 -5.77276 6.31779 -0.0821136 +4265 4 33.06 5.8369 24.6155 -4.37455 2.20678 -7.03208 +4266 6 44.2424 18.1337 27.2287 35.5912 4.17402 -1.61274 +4267 4 44.1428 18.6708 26.4104 -1.15401 -3.8952 20.8354 +4268 4 45.2041 18.2132 27.495 -32.4507 -0.562547 -10.2772 +4269 6 5.27745 36.9951 29.0779 -48.9341 45.2857 -18.2185 +4270 4 4.83797 37.847 28.7 19.7525 -41.2711 21.6555 +4271 4 6.18662 37.2124 29.1987 31.023 4.60304 7.81739 +4272 6 20.0415 5.02171 38.9415 13.5567 -45.1901 -20.6947 +4273 4 19.673 5.46942 39.6755 -5.65499 20.9205 26.8401 +4274 4 20.3443 4.13258 39.2728 -11.021 23.424 -4.53385 +4275 6 17.9077 2.77821 33.872 -28.7289 7.66476 22.1934 +4276 4 18.5675 3.36618 33.4993 11.2764 5.36232 -3.32863 +4277 4 17.289 3.30252 34.4687 25.3234 -20.0176 -17.8345 +4278 6 5.56252 23.3664 22.3199 23.4646 34.0494 22.6536 +4279 4 6.31266 23.4141 21.6995 -10.6272 -11.1368 -5.13028 +4280 4 5.83055 24.0852 22.9498 -18.4748 -15.0058 -11.9197 +4281 6 12.7366 28.0136 40.0786 16.9267 17.0007 -14.1953 +4282 4 12.7736 28.981 40.2539 2.04889 -13.1204 -10.7842 +4283 4 13.1752 27.8683 39.2015 -12.0592 5.90979 20.7524 +4284 6 50.5208 38.8121 28.4283 -2.96204 -29.3557 2.62021 +4285 4 51.1161 39.4306 28.008 -0.383593 20.3423 -2.32338 +4286 4 49.7133 39.2143 28.7877 7.69194 10.1621 -6.76025 +4287 6 33.551 8.21903 17.8634 -36.1599 -47.4859 45.2019 +4288 4 33.9333 8.85376 17.3385 32.2471 57.3944 -47.1321 +4289 4 33.8604 7.38657 17.5128 5.83122 -9.97324 -0.737685 +4290 6 34.648 34.7105 17.7828 9.01761 -19.7832 -8.77749 +4291 4 35.1788 35.3328 18.2888 -3.00831 8.66808 4.62333 +4292 4 35.2883 34.0014 17.5711 -12.5093 2.94991 -0.39307 +4293 6 40.7261 5.27864 23.3991 8.21105 0.19251 11.4926 +4294 4 41.4259 4.93717 23.9966 -11.2767 2.88733 -17.4667 +4295 4 40.0598 4.58084 23.2941 1.87831 5.06613 5.43463 +4296 6 16.9137 27.769 14.4809 73.6258 -34.7175 -8.82476 +4297 4 16.0667 28.1115 14.4612 -62.8462 32.6704 -2.60496 +4298 4 17.5486 28.5101 14.4313 -15.9271 -1.25076 7.8547 +4299 6 29.0219 14.6595 5.00786 20.8741 -13.5443 13.1138 +4300 4 29.536 13.8229 4.89138 -12.0375 16.0826 3.98067 +4301 4 28.8859 14.7576 5.97494 -2.91261 0.0620574 -16.4413 +4302 6 36.854 17.7325 5.08016 4.48522 -18.3735 -43.8449 +4303 4 36.2168 18.3553 5.39001 -11.7806 18.6728 17.0618 +4304 4 36.8305 17.8608 4.09391 11.7548 -5.76061 25.8999 +4305 6 27.7142 25.5094 34.8662 20.7401 -29.3529 -12.6468 +4306 4 28.3997 25.1535 35.4786 -13.7878 13.2187 -9.69645 +4307 4 27.3728 26.292 35.2699 -5.77421 14.8272 18.3022 +4308 6 24.7481 17.2805 18.0642 -3.31447 -10.4308 -2.46491 +4309 4 25.3087 17.9154 18.5049 2.27957 10.048 8.00722 +4310 4 24.0564 17.0505 18.7104 4.01172 4.3516 -6.8818 +4311 6 30.1789 1.58441 5.83411 4.12275 19.8646 -71.4749 +4312 4 29.4821 1.85802 6.42075 -6.9839 1.28517 8.89789 +4313 4 29.959 2.0434 4.91278 6.77151 -29.6581 61.3265 +4314 6 37.452 25.891 8.43789 -40.1641 -31.4732 50.6902 +4315 4 38.334 25.9927 8.78667 20.6785 -4.95116 -4.15592 +4316 4 36.9881 25.2791 9.14634 19.6253 32.8331 -49.0064 +4317 6 24.7604 7.00734 2.27008 32.0581 9.85747 -12.4546 +4318 4 25.4028 6.31463 2.48931 -5.40489 7.62931 7.6933 +4319 4 23.9158 6.58667 2.26874 -21.5893 -3.78057 4.11792 +4320 6 25.7887 38.8506 10.7619 -30.5475 28.1992 -59.3139 +4321 4 26.3103 38.4194 11.381 38.5207 -12.4255 48.7922 +4322 4 26.1525 39.7259 10.4932 -1.18865 -9.03037 15.3914 +4323 6 0.555207 13.578 28.1388 12.6332 42.7054 11.738 +4324 4 0.341766 12.7807 27.7179 -10.1825 -36.9478 -16.4943 +4325 4 0.413626 13.4435 29.0864 -5.17296 -1.28815 -2.85065 +4326 6 20.4105 17.1191 12.037 -17.9302 -38.4569 -26.5492 +4327 4 20.2295 17.2547 12.9605 -1.34068 5.07474 20.9983 +4328 4 19.8884 16.3005 11.7926 16.4515 20.0565 4.33162 +4329 6 30.9925 7.37797 16.6653 29.7996 22.3073 3.61878 +4330 4 31.2643 7.03844 15.7784 -2.63758 10.9944 17.123 +4331 4 31.7569 7.94595 17.0261 -27.6116 -29.8279 -14.8225 +4332 6 10.2093 5.78517 12.1714 32.5037 6.96704 58.397 +4333 4 10.1014 6.35617 11.4591 -8.08786 32.1119 -50.7901 +4334 4 9.65707 5.06197 12.024 -36.7963 -41.1043 -15.4671 +4335 6 18.4347 31.3493 24.155 3.48135 -6.25246 2.65688 +4336 4 18.4439 30.3878 24.2879 -2.95335 1.71216 0.944019 +4337 4 18.3198 31.7316 25.0273 -3.67252 2.09543 1.27238 +4338 6 27.8948 29.2525 29.2666 2.33504 21.8021 -21.5937 +4339 4 28.3627 29.5914 28.4251 -11.9103 -18.4763 37.4515 +4340 4 28.5196 28.9609 29.9463 14.9294 0.890267 -8.6061 +4341 6 38.3738 15.4456 29.791 12.9945 -28.6313 15.0543 +4342 4 38.0891 14.5036 30.0544 22.1369 39.5396 -7.74746 +4343 4 39.2957 15.632 30.1541 -37.4531 -3.97597 -10.3113 +4344 6 21.7041 34.7992 5.56934 -10.1436 -56.1371 25.2208 +4345 4 21.4621 33.8673 5.89439 16.7439 32.0975 -19.9868 +4346 4 20.9431 35.2741 5.907 -2.46203 13.3807 -4.97838 +4347 6 18.2064 16.8274 1.01093 1.02147 5.09087 9.91972 +4348 4 17.6405 17.264 0.353478 -0.489627 -6.58546 6.49815 +4349 4 17.8529 17.0628 1.89865 0.517006 0.361128 -13.8735 +4350 6 43.5166 18.4972 39.3436 16.5286 13.9247 -42.0759 +4351 4 43.0101 19.1966 39.7112 -21.9319 15.1254 24.622 +4352 4 43.7095 18.933 38.4597 1.00685 -29.3013 20.2287 +4353 6 17.7976 10.0688 35.5434 7.86102 19.599 -20.2005 +4354 4 17.8945 9.40709 36.2105 4.74187 -18.2058 11.3424 +4355 4 18.5459 9.97323 34.9151 -16.2901 -5.18221 9.2364 +4356 6 36.5889 30.5599 29.0828 -33.0481 48.6405 -12.465 +4357 4 36.5132 31.4977 28.7143 1.54088 -37.0728 8.50934 +4358 4 37.4982 30.324 28.9756 25.7485 -11.7594 -3.68806 +4359 6 38.4943 35.9682 10.4222 10.3079 16.2999 40.226 +4360 4 38.6552 36.6966 11.1228 -3.33458 -34.9071 -25.8136 +4361 4 38.3509 35.1294 10.9235 4.16648 17.1849 -3.98913 +4362 6 43.4036 18.8037 34.3607 -18.7725 -42.8138 41.3108 +4363 4 42.9709 18.1893 33.7432 11.3097 10.906 -2.86187 +4364 4 43.2777 18.3171 35.2411 6.94038 29.5352 -30.5758 +4365 6 11.0585 40.2128 6.10885 -15.7783 5.94868 1.16987 +4366 4 11.5965 40.9262 6.45194 10.3679 4.26541 4.32644 +4367 4 10.1443 40.5526 6.13585 6.40705 -5.05479 -5.29954 +4368 6 48.3342 13.7493 24.4707 -3.46168 30.4962 28.8754 +4369 4 47.8576 13.3588 23.754 -13.8134 -6.92474 -20.9085 +4370 4 47.8711 14.5963 24.7134 14.7345 -25.1065 -10.1999 +4371 6 1.47205 25.7712 23.7829 0.184952 23.7651 -2.41746 +4372 4 0.854396 26.4618 23.4919 -3.79407 -11.1699 -2.17794 +4373 4 2.13056 26.3319 24.2122 9.67536 -12.9921 7.11562 +4374 6 20.5856 0.045789 21.1048 4.96875 -22.7073 -7.43464 +4375 4 19.8117 0.249922 21.5931 -19.4423 21.7426 16.1957 +4376 4 20.4519 41.001 21.0443 13.8042 -0.350206 -3.82588 +4377 6 37.6675 12.896 30.7055 18.9575 -14.1068 -43.1025 +4378 4 37.1872 12.5493 29.907 3.14127 2.53034 24.3729 +4379 4 37.0391 13.1763 31.3358 -31.377 6.23238 20.3235 +4380 6 49.4665 17.3801 9.24655 -8.32961 25.946 -15.5009 +4381 4 48.5345 17.665 9.32633 16.3924 -11.5392 1.15372 +4382 4 49.8219 17.9883 8.54454 -1.98957 -21.6031 19.5257 +4383 6 34.3643 5.3502 17.1421 32.952 7.78829 -18.2658 +4384 4 34.6245 5.26975 16.1857 -14.4704 2.64329 20.4158 +4385 4 33.4298 5.20109 17.2262 -20.6176 -11.2241 -0.901893 +4386 6 14.7832 27.6655 0.085624 -10.3553 13.8949 -22.792 +4387 4 14.1034 27.8892 41.3249 2.03342 -11.2849 14.5146 +4388 4 15.1757 28.5319 0.287496 2.39463 -6.00136 9.68974 +4389 6 48.8635 15.5211 20.7504 -7.30397 3.37214 15.1279 +4390 4 49.1252 16.3754 20.4371 0.183023 13.7927 -3.76167 +4391 4 49.1585 14.9241 20.0762 3.93917 -17.6947 -14.7742 +4392 6 23.8074 40.3851 20.3877 -2.3041 21.5375 32.1864 +4393 4 23.5266 40.991 21.1382 8.45078 -18.9812 -28.3519 +4394 4 24.6929 40.0818 20.645 -4.8729 5.63426 -4.96266 +4395 6 35.18 31.4993 13.7142 -38.6695 32.0432 -41.3249 +4396 4 34.2219 31.3119 13.4889 30.0091 9.93153 3.95626 +4397 4 35.4367 30.7845 14.243 12.3636 -35.8089 30.5679 +4398 6 10.9775 9.01115 39.5206 -26.3812 35.8658 -19.2594 +4399 4 10.5557 9.91556 39.5205 15.5031 -28.3669 -8.85108 +4400 4 11.1542 8.87096 40.4393 5.31517 -3.54045 10.232 +4401 6 53.2061 4.88103 16.6049 -20.6689 -12.7794 3.6937 +4402 4 53.6782 5.3887 17.2239 33.7717 25.1716 19.5104 +4403 4 52.5676 4.51498 17.2255 -11.3933 -13.1169 -19.2452 +4404 6 7.83562 33.8039 26.1496 42.0062 50.3869 -17.047 +4405 4 7.62463 34.1533 27.0155 -6.33847 -9.39794 9.82588 +4406 4 8.42034 34.5749 25.7852 -30.6961 -50.8642 6.91563 +4407 6 31.3279 27.9472 6.28298 4.37835 -19.3247 -9.6219 +4408 4 31.922 27.5111 6.93657 -10.4846 5.09347 -11.9486 +4409 4 31.1129 27.3323 5.53276 6.79934 9.76999 15.6259 +4410 6 31.3655 2.17383 41.055 18.9421 -1.98994 34.5993 +4411 4 31.8109 2.17902 0.04034 -17.0754 7.04602 -28.7946 +4412 4 31.2404 1.23747 40.9086 -7.00813 -7.80206 -8.22245 +4413 6 33.7652 4.25739 35.9001 -31.2863 -13.3655 20.8802 +4414 4 34.2485 3.80076 36.6104 5.56552 8.36292 -9.80816 +4415 4 32.8077 4.13792 36.1863 30.7439 3.51509 -16.9094 +4416 6 47.9725 16.0636 29.8584 -12.289 -4.0311 -5.35812 +4417 4 48.7208 16.4163 30.3732 -4.13056 -10.8519 0.408936 +4418 4 47.3533 15.5947 30.4559 16.7379 8.85318 -0.563064 +4419 6 49.3385 10.0935 28.5885 -11.8118 4.56009 -13.0989 +4420 4 48.5886 10.6638 28.8239 3.51911 -4.5157 1.44109 +4421 4 49.3924 10.1159 27.6088 6.69909 -1.91925 15.8757 +4422 6 21.4187 27.7693 29.76 2.80336 -20.4787 -6.37736 +4423 4 21.861 27.2354 30.4624 -7.84738 15.6574 -13.8161 +4424 4 21.1828 28.6282 30.0799 2.10219 20.3695 17.9057 +4425 6 11.6757 39.482 25.8517 13.5538 20.9417 -1.29545 +4426 4 12.2965 38.7786 26.0889 -7.12508 -2.9493 -2.05027 +4427 4 10.8193 39.0846 25.7116 -11.9056 -6.20494 0.0112269 +4428 6 22.9798 39.311 7.85817 -12.7601 -4.86939 -3.04246 +4429 4 22.3059 38.6219 7.95844 1.92638 3.98273 0.136758 +4430 4 22.5772 40.0658 8.31757 9.04497 -1.85468 3.82529 +4431 6 42.5415 35.9278 31.3391 13.0935 -70.9729 -20.1514 +4432 4 42.6447 35.4696 30.4714 -5.52665 5.17936 25.8951 +4433 4 42.5102 36.7973 31.0384 -8.93799 60.9387 2.27408 +4434 6 33.663 14.7412 3.98499 30.4225 -17.693 -39.6888 +4435 4 32.8564 15.2185 4.09596 -24.3526 16.5192 2.50389 +4436 4 33.8944 14.7916 3.00116 -11.9532 1.40502 32.6284 +4437 6 36.697 8.6017 17.5153 18.7294 -29.9333 -4.55465 +4438 4 37.1702 7.95911 16.9159 -11.687 24.5338 13.7544 +4439 4 36.2734 9.25409 16.9543 -7.54123 3.80926 -6.08989 +4440 6 20.8295 32.4146 17.3309 -48.7404 -21.5825 11.0081 +4441 4 20.1664 32.9726 16.9048 10.2664 9.72211 -3.82622 +4442 4 20.2271 31.8015 17.8465 35.2036 12.7196 -8.50107 +4443 6 20.7003 35.3218 14.1083 -3.44914 -18.0461 -19.2112 +4444 4 21.3182 35.5386 13.4099 3.08163 2.90557 -13.4495 +4445 4 20.919 35.9437 14.7754 1.56244 13.5022 22.2067 +4446 6 20.2323 2.51936 40.1651 -9.22326 -14.3688 36.1644 +4447 4 19.7926 2.34354 41.0434 13.5524 6.30823 -28.5037 +4448 4 20.7516 1.7186 40.0171 -1.27786 1.50094 -7.75906 +4449 6 15.0477 14.4672 0.24789 12.9865 -5.55034 -72.7807 +4450 4 15.4827 13.6954 41.6877 -12.87 20.0829 29.6139 +4451 4 15.2186 15.2036 41.5094 -2.93016 -13.2387 23.097 +4452 6 24.8149 37.3373 18.5213 2.43631 -2.68492 27.9859 +4453 4 24.4361 37.9203 17.8611 -0.249038 9.91659 1.71419 +4454 4 24.5604 37.6468 19.4234 0.486379 -6.00228 -23.279 +4455 6 3.16989 27.7944 5.24229 1.80682 -16.6913 61.515 +4456 4 2.664 27.92 6.09489 -0.254446 2.50987 -32.3978 +4457 4 4.0252 27.4816 5.63916 -14.135 1.37322 -28.2843 +4458 6 37.1257 39.0598 36.0573 4.58816 40.5807 23.3296 +4459 4 37.5599 39.5885 36.7783 -22.7086 -1.13864 -22.8071 +4460 4 37.5439 38.2379 36.1828 13.5973 -37.3165 -5.96047 +4461 6 41.3477 16.3672 3.84024 25.8131 6.72768 37.2631 +4462 4 41.4431 17.3182 3.89206 -17.3786 8.01961 -13.1803 +4463 4 42.0046 16.1549 4.54461 -14.0821 -19.2698 -21.0799 +4464 6 15.5755 3.1684 35.3585 1.47298 2.70845 -61.2084 +4465 4 15.1145 3.59171 34.5864 10.479 -16.2188 17.3147 +4466 4 15.2032 3.60881 36.0782 -15.9672 22.7619 40.5269 +4467 6 33.1731 24.2438 7.96729 6.41569 -10.7526 14.1331 +4468 4 33.3408 24.6773 7.1445 11.9115 -7.07525 -26.7187 +4469 4 32.5824 24.8707 8.33408 -19.4303 14.6961 21.7816 +4470 6 35.865 29.7374 15.5979 -29.8607 35.3275 -32.1308 +4471 4 36.7747 29.6672 15.7703 43.701 -12.5229 16.5971 +4472 4 35.3562 29.0371 15.9739 2.56537 -15.478 18.0667 +4473 6 17.5843 36.8354 41.8728 12.1708 -5.57123 -52.5088 +4474 4 18.1833 36.773 0.675699 12.2604 -1.93512 36.5948 +4475 4 18.2359 36.8623 41.125 -21.8566 7.06165 11.6698 +4476 6 26.5622 4.14672 31.1307 -32.6289 -51.1506 -31.7953 +4477 4 27.2582 4.59627 31.5457 41.9615 24.0313 17.3243 +4478 4 26.8928 3.23766 30.8727 -4.86114 29.783 15.5489 +4479 6 31.9552 1.33198 34.4369 -14.3248 -8.90334 35.5546 +4480 4 32.7269 1.15305 34.9944 8.32726 6.02564 -17.2377 +4481 4 31.2642 1.08685 35.0838 -0.545778 4.81468 -20.3916 +4482 6 24.491 14.7534 2.38457 33.2042 -23.9469 17.2683 +4483 4 24.2753 13.9637 2.92779 -7.56186 18.0622 -11.5291 +4484 4 25.4626 14.8414 2.55985 -20.2114 8.54272 -9.97318 +4485 6 25.7566 20.9055 27.5389 -1.15091 7.1508 6.95521 +4486 4 25.459 20.6057 28.4261 8.17968 -1.38894 -17.9407 +4487 4 25.6371 21.8685 27.5748 1.97223 -1.15564 -2.97875 +4488 6 18.1445 40.1527 30.6395 17.3729 -20.3781 15.2884 +4489 4 18.5141 39.2638 30.8544 -10.5973 16.1604 -9.36512 +4490 4 18.9393 40.7073 30.6583 -6.94059 7.54086 -5.9327 +4491 6 46.7889 23.8914 24.5979 7.31075 41.4222 -46.8858 +4492 4 46.2898 24.602 24.0741 10.6002 -32.8666 22.2289 +4493 4 47.4121 23.5287 23.9473 -6.99108 -0.957122 4.26591 +4494 6 45.6201 22.6921 26.5067 -14.1777 -10.0967 -12.8229 +4495 4 46.0372 22.9342 25.6668 -2.41585 -1.26552 16.8561 +4496 4 46.0784 23.1676 27.2003 -0.61408 1.28207 1.11474 +4497 6 20.1006 4.48803 26.6974 -40.8522 40.1383 42.8029 +4498 4 20.2489 5.43817 26.4853 8.37449 -26.4011 -0.951475 +4499 4 20.6602 3.93368 26.2205 34.0606 -24.4352 -38.1565 +4500 6 35.278 26.5864 12.552 0.280065 20.4825 10.9931 +4501 4 35.6728 25.7022 12.4634 2.08478 13.3641 8.87461 +4502 4 35.7774 27.1222 13.2104 -5.20465 -19.6779 -15.4464 +4503 6 3.25879 33.9669 12.2907 -5.01808 -25.4739 5.3677 +4504 4 2.34263 33.6224 12.3201 4.20809 12.7539 -0.381501 +4505 4 3.26735 34.9165 12.3326 -4.58918 17.9212 0.78916 +4506 6 36.6873 1.27899 25.5756 -31.8717 2.25298 32.7844 +4507 4 37.6116 1.37326 25.7779 18.4499 5.6721 -4.77344 +4508 4 36.2122 1.51788 26.4163 6.97172 -2.04149 -25.7728 +4509 6 16.8705 4.65685 24.0413 -35.5309 2.76318 -23.9776 +4510 4 15.8575 4.70434 23.9217 47.0687 -0.0954558 1.21401 +4511 4 17.247 4.33879 23.186 -5.50277 -2.28941 17.9023 +4512 6 39.6565 15.0715 7.80572 25.6093 19.6796 32.1194 +4513 4 39.2854 14.2576 8.13712 -9.42359 -13.1845 -9.18942 +4514 4 39.3628 15.2517 6.91527 -5.26665 -12.4192 -5.15573 +4515 6 9.97948 20.1659 2.91877 -9.38613 14.9664 11.2777 +4516 4 9.63877 20.6452 2.15027 4.12295 -11.9706 -3.67253 +4517 4 9.85969 19.2106 2.80597 1.71997 13.0916 -4.74013 +4518 6 23.4135 4.6314 15.2717 1.19087 -47.3757 24.1847 +4519 4 23.6596 4.57091 14.3636 3.27412 12.4021 -25.8415 +4520 4 23.0767 5.481 15.4712 -5.64379 31.4202 -0.243197 +4521 6 23.5143 41.6409 17.9193 15.1077 8.25095 -6.6202 +4522 4 23.8837 41.2632 18.7444 -17.9015 4.85421 -1.14363 +4523 4 22.6477 0.129763 18.1032 2.89941 -5.9973 3.37217 +4524 6 30.9257 4.8197 1.33225 52.4556 82.2644 21.8498 +4525 4 30.6067 4.04082 1.0087 -28.5575 -73.6424 -29.1188 +4526 4 31.8008 4.99709 0.898826 -20.2281 -12.9509 7.44496 +4527 6 29.2107 33.7595 18.6102 73.0072 -21.2941 -2.29721 +4528 4 30.2072 34.0216 18.5444 -47.9733 -6.17517 5.28057 +4529 4 28.7323 34.5281 18.37 -21.0864 31.3556 1.11974 +4530 6 23.1159 16.7161 3.6681 15.0693 -22.2232 4.2808 +4531 4 23.7494 16.3853 2.99745 -15.1451 3.0429 8.25243 +4532 4 23.0882 17.666 3.59926 -2.15966 11.8771 -4.335 +4533 6 34.9011 26.7664 31.7501 -1.76717 8.52767 -40.8429 +4534 4 35.037 27.6398 31.3273 1.29043 -2.59798 26.5044 +4535 4 34.999 26.223 30.9552 -0.698038 -3.54606 8.98008 +4536 6 7.10213 40.7731 20.9713 24.4432 1.2064 -5.23395 +4537 4 6.57619 40.3882 20.2802 -20.054 -4.79313 -9.64846 +4538 4 7.95521 40.8692 20.51 0.818491 4.17448 7.60026 +4539 6 52.4557 9.69054 11.9333 -13.8891 -19.4181 -13.3487 +4540 4 52.1298 8.88818 11.4535 9.48574 25.0976 13.8313 +4541 4 53.1611 10.0725 11.3936 -7.122 -1.8527 1.23238 +4542 6 12.0235 32.7598 27.7442 3.70099 -7.78602 -3.89203 +4543 4 11.3626 32.1501 27.3892 -5.86407 9.3821 3.02313 +4544 4 12.7405 32.6461 27.1218 9.18069 3.19616 2.31322 +4545 6 15.7918 18.546 0.850378 10.8461 -1.95532 -11.5883 +4546 4 16.438 18.9813 1.41668 1.29405 -2.87095 0.147979 +4547 4 14.9753 18.6242 1.3119 -21.1882 -0.0291689 9.92309 +4548 6 30.9967 13.9378 7.42939 11.475 1.61738 -44.5395 +4549 4 31.0432 13.5913 6.48715 -7.7997 1.97415 36.5778 +4550 4 31.6719 14.6391 7.43931 -7.46887 -7.66354 10.6483 +4551 6 23.9383 39.564 3.55488 34.3001 -22.0749 -10.0269 +4552 4 24.3437 38.8163 4.07249 -17.2972 16.8542 -11.2744 +4553 4 24.6493 39.7352 2.88999 -19.8697 7.819 10.5959 +4554 6 53.2452 13.9576 2.00229 -14.7116 -5.90049 -8.44118 +4555 4 54.0493 14.3984 2.24709 19.6807 0.169927 9.22775 +4556 4 52.9645 14.4205 1.20429 2.95034 -7.59818 -1.70329 +4557 6 29.4557 26.4275 7.80964 12.1022 6.02758 -9.79702 +4558 4 29.9353 26.7368 7.00545 -17.6775 -4.91001 19.2628 +4559 4 28.525 26.2807 7.58748 -5.08244 6.84096 -3.37299 +4560 6 24.6247 23.6022 31.0889 -22.8452 23.3962 -39.3716 +4561 4 23.7242 23.1866 30.9343 31.0198 16.8155 5.56769 +4562 4 24.7802 24.3072 30.3632 -7.32447 -41.3429 34.091 +4563 6 33.6649 19.3163 40.5091 -6.65541 -1.27585 7.81728 +4564 4 33.8354 18.657 41.2044 -1.67667 1.74775 -3.87809 +4565 4 34.3105 19.1562 39.8145 2.0445 4.20075 -4.1701 +4566 6 0.559384 35.9874 14.2134 5.8565 -19.6842 -1.82955 +4567 4 1.23941 35.9463 14.8996 -3.202 15.0395 2.84586 +4568 4 0.030681 36.7785 14.2979 -4.01885 14.7851 6.49139 +4569 6 7.05661 12.759 15.7779 -22.8667 -6.52104 17.6379 +4570 4 6.34583 12.5966 16.4564 20.9558 0.33122 -21.552 +4571 4 6.91757 12.0848 15.0954 -2.34629 3.44815 6.08752 +4572 6 7.88282 3.87818 22.4173 5.89555 -44.5054 15.1514 +4573 4 7.49019 4.56914 21.9267 -7.80716 26.896 -25.5563 +4574 4 7.61791 3.03791 21.9647 5.08594 18.6769 15.1101 +4575 6 50.7471 32.0888 16.2401 1.83727 42.1646 -7.06137 +4576 4 49.8752 31.8312 16.5285 -7.29916 -4.21179 -0.512004 +4577 4 50.6362 33.057 15.9791 5.96194 -37.4522 8.78354 +4578 6 15.303 18.2089 30.059 10.7923 -22.0796 25.2673 +4579 4 14.9011 18.5061 29.2675 -14.0638 14.0876 -27.3921 +4580 4 14.9173 17.3208 30.1974 9.34767 8.93092 3.04247 +4581 6 36.7231 25.4597 33.3812 -54.2725 16.2506 -34.9161 +4582 4 35.9173 25.838 32.8237 55.5216 -11.0114 39.6871 +4583 4 36.747 24.5432 33.1027 5.79642 -6.85026 5.14009 +4584 6 16.5358 21.8507 20.2615 -17.2006 3.10996 -10.5852 +4585 4 16.5318 20.9271 19.9881 4.62491 -6.39719 -1.16283 +4586 4 16.2171 22.3466 19.4835 8.40466 -0.269645 8.83911 +4587 6 44.2784 3.11614 30.075 -4.29151 -10.9085 31.9498 +4588 4 44.2908 2.23086 29.7056 -5.3385 -9.83615 -1.81045 +4589 4 44.5205 3.68982 29.3775 9.49019 22.102 -29.428 +4590 6 51.0822 14.1295 27.7742 -18.732 -33.3382 -1.30318 +4591 4 51.215 15.0658 27.7997 -1.99026 24.8352 -0.164216 +4592 4 50.1181 13.9695 27.6298 18.0185 9.91077 0.913588 +4593 6 54.1414 15.8836 27.1251 18.1892 -50.717 -21.9912 +4594 4 54.5758 14.9905 27.2793 -7.90108 34.3346 13.352 +4595 4 53.8259 15.7459 26.2068 -12.5208 17.6482 15.4671 +4596 6 26.7107 15.1629 34.529 26.3006 32.6175 -12.2305 +4597 4 26.7089 16.144 34.4655 -8.86078 -18.0829 7.52702 +4598 4 27.5163 14.9973 34.009 -10.4907 -11.0891 -0.654257 +4599 6 34.6699 2.22267 27.4725 27.1341 -12.2799 29.337 +4600 4 34.3153 1.93716 28.3227 7.08088 3.88889 7.09202 +4601 4 33.8991 2.25298 26.9555 -28.541 9.30381 -28.496 +4602 6 36.3083 17.6409 40.3953 7.68303 1.60807 9.57574 +4603 4 35.716 17.1791 39.8253 -12.5236 -4.37947 -14.4862 +4604 4 36.6569 16.9265 40.9504 1.18426 15.263 2.6664 +4605 6 26.2972 0.194896 33.0957 0.945324 -1.75644 -10.1569 +4606 4 26.0926 0.771392 33.8475 -8.68516 2.0119 1.91424 +4607 4 25.4691 41.6865 32.8295 -8.00507 -1.67316 12.192 +4608 6 5.19113 35.5773 31.6357 23.2413 -27.7984 27.0466 +4609 4 6.1476 35.7159 31.7435 -10.1506 4.22761 6.12862 +4610 4 4.96861 36.095 30.8978 -11.7512 22.2076 -38.0194 +4611 6 20.2191 22.0354 35.1304 9.30742 -6.19625 19.4235 +4612 4 19.9844 21.2003 34.7289 -5.16022 -6.81034 -3.33987 +4613 4 20.4782 21.7596 36.0473 -3.02096 9.85719 -25.9724 +4614 6 15.9251 36.5949 36.947 -9.13121 -30.7472 31.1466 +4615 4 16.4837 37.3712 37.0549 6.13876 -3.03661 -2.05614 +4616 4 16.031 36.0658 37.8159 -5.1453 16.1721 -39.9007 +4617 6 30.9484 22.4015 3.56131 11.993 -60.8988 -15.4947 +4618 4 31.1008 22.6958 4.44557 1.55935 5.74187 27.4751 +4619 4 31.2551 21.4217 3.58407 -13.4398 43.4536 -6.61432 +4620 6 47.0429 8.40936 14.2086 -4.42011 -15.6298 -34.0486 +4621 4 46.2603 8.29509 13.606 17.325 5.05196 18.7602 +4622 4 47.7698 7.89697 13.7682 -18.8904 11.0332 12.0247 +4623 6 34.1011 18.6159 3.148 0.361877 23.965 35.4915 +4624 4 34.6363 18.3397 3.89922 -0.845538 -0.743075 -4.07575 +4625 4 34.3812 18.1265 2.40098 2.04544 -17.9565 -29.3984 +4626 6 26.7996 25.3961 12.3408 -30.8906 -54.2954 26.5725 +4627 4 27.3117 26.1608 12.4557 20.536 44.4803 3.39785 +4628 4 26.6414 25.0259 13.2528 6.28377 9.49183 -30.6151 +4629 6 22.6108 25.7845 30.8845 17.3255 -0.303924 3.7754 +4630 4 23.4288 25.6954 31.4132 -11.344 -1.13015 -1.03332 +4631 4 22.2314 24.9052 30.7722 1.09512 -5.6623 7.4309 +4632 6 23.6311 9.76276 35.7585 -2.90797 -4.19552 -4.78319 +4633 4 22.8314 10.2832 35.6581 -5.74139 5.63622 4.02691 +4634 4 23.3139 8.86685 35.4998 11.2809 19.0625 6.63709 +4635 6 10.4076 36.7742 9.64242 -28.436 -9.9846 9.32351 +4636 4 9.50067 36.3875 9.59353 19.7531 11.7612 -0.53903 +4637 4 10.7226 36.8301 8.7426 3.69205 5.92187 -13.8772 +4638 6 4.00038 32.4265 25.8669 22.0714 10.4661 11.4497 +4639 4 4.38844 32.9375 25.1422 -1.34031 3.54398 1.69886 +4640 4 3.2706 31.9516 25.4996 -17.8371 -17.4963 -10.4987 +4641 6 29.085 26.0296 18.6527 19.273 -47.5776 11.2122 +4642 4 28.2115 26.0231 19.0264 -21.1607 3.13806 -0.423844 +4643 4 29.4632 25.1291 18.9323 -7.10954 42.4601 -14.5827 +4644 6 15.3089 1.3255 27.9792 -24.1234 20.5069 -17.5654 +4645 4 15.0496 0.974163 27.1169 2.04641 -4.01433 11.5068 +4646 4 14.7355 2.12388 28.0804 19.9995 -12.8223 4.08523 +4647 6 48.6106 2.88816 22.9655 -1.26722 3.55247 -0.201848 +4648 4 48.4165 2.02818 22.6182 -14.5439 -12.5884 3.03438 +4649 4 49.5001 2.98572 22.6432 10.4652 10.9023 -5.33271 +4650 6 53.0075 0.36099 19.7296 11.424 -8.43987 -8.95848 +4651 4 52.5965 41.9022 20.5162 -3.41206 4.78179 6.33318 +4652 4 52.3731 0.223553 19.0136 -6.83989 5.16364 0.289704 +4653 6 1.41074 17.5036 17.9462 -15.7932 -16.9445 -5.36496 +4654 4 1.29993 17.3585 17.0019 -2.92928 12.5396 -5.88676 +4655 4 1.38271 16.6004 18.2823 6.65411 -3.00458 14.0519 +4656 6 37.9084 19.0323 37.6056 -38.9323 8.68785 -13.5971 +4657 4 36.9858 18.7285 37.7384 11.3307 8.89304 -0.372118 +4658 4 38.4207 18.4342 38.1195 19.3518 -17.7067 16.118 +4659 6 26.9813 30.3571 38.0896 -0.527767 18.5171 -30.3811 +4660 4 26.1212 30.285 37.6565 1.23907 -9.17466 9.80696 +4661 4 27.2764 31.2069 37.701 2.1524 -13.2267 12.8694 +4662 6 20.0955 18.5722 3.03696 10.9017 21.9571 9.92937 +4663 4 20.0263 17.806 3.59422 -10.4522 -23.2015 2.62566 +4664 4 20.8322 19.0363 3.46766 -4.52129 0.073665 -16.3651 +4665 6 35.0841 6.94694 4.08385 8.40312 -14.6319 10.4582 +4666 4 35.6826 7.16069 3.3578 -1.64356 4.34706 -6.00978 +4667 4 34.2613 7.42764 3.99145 -7.61312 4.93718 -6.31016 +4668 6 22.2176 37.0878 31.2599 -35.8324 13.882 69.7054 +4669 4 22.1593 36.8558 30.3798 -4.04212 -13.8909 -61.3413 +4670 4 21.2552 37.1952 31.5589 44.4461 1.84169 -14.4682 +4671 6 12.3904 22.3711 41.8265 33.9103 21.3816 -17.5574 +4672 4 13.0623 23.0096 41.4404 -31.3175 -17.017 24.3472 +4673 4 11.7392 22.2302 41.1411 -5.71588 1.3909 -0.895108 +4674 6 43.2333 30.3145 23.1566 26.412 30.0652 1.94466 +4675 4 44.1443 29.9954 22.911 -23.9673 11.2944 4.28313 +4676 4 43.3588 31.2906 23.3811 -4.98348 -33.6726 -4.24118 +4677 6 16.5316 8.07904 16.6592 -13.1305 -2.58289 1.30551 +4678 4 16.426 8.46358 15.7881 -7.07274 -4.02537 -8.52635 +4679 4 17.4421 8.27811 16.8595 11.8389 2.77268 11.6749 +4680 6 10.0527 8.64979 31.7837 -8.97334 17.7557 -57.5223 +4681 4 10.1312 7.90747 32.3291 5.58005 -27.1767 37.8097 +4682 4 10.1183 9.47003 32.2578 1.92783 9.29621 23.4619 +4683 6 10.1389 6.52097 25.6279 25.2027 -9.57639 0.964906 +4684 4 9.42987 6.19895 26.1639 -19.2857 -8.54063 7.31181 +4685 4 9.7626 7.17299 25.0306 4.07146 -2.80849 4.96109 +4686 6 49.8614 7.23714 25.5252 -17.9172 7.62946 -5.56104 +4687 4 50.0467 6.31121 25.4422 2.69032 -18.6529 -6.42341 +4688 4 50.6907 7.63095 25.75 18.9978 12.6416 8.6826 +4689 6 18.4677 37.5766 33.9365 -27.5019 7.45217 1.11424 +4690 4 17.6855 38.1606 34.0956 24.1544 -3.52274 -4.16364 +4691 4 18.0518 36.7105 34.0373 4.53854 -5.63623 -1.47673 +4692 6 32.1991 34.7999 39.2511 37.7035 -28.7103 22.0041 +4693 4 32.3976 34.2973 40.087 0.14143 15.1618 -21.7552 +4694 4 31.3182 35.0784 39.3573 -42.2601 10.9481 4.26487 +4695 6 49.5371 23.9083 4.45427 26.1113 1.30104 -36.4507 +4696 4 49.7626 23.2251 5.06121 8.22711 -23.3511 16.8473 +4697 4 48.7895 24.3154 4.8182 -37.5883 23.1909 21.4935 +4698 6 6.05615 24.4755 33.9372 -3.62864 21.1406 1.2609 +4699 4 6.78781 23.8493 33.8811 -5.98028 -5.90455 -1.42734 +4700 4 5.44033 24.2071 34.6424 10.5748 -4.32926 -7.84557 +4701 6 1.71417 22.9797 24.1919 12.9465 25.751 -13.942 +4702 4 1.74027 23.9063 23.8744 -7.21984 -9.04225 7.93975 +4703 4 0.785802 22.7901 24.3299 -10.4675 -5.82386 8.34916 +4704 6 12.4544 16.5695 32.338 -33.1179 2.9171 31.5337 +4705 4 13.1434 15.995 32.5512 52.391 -27.2499 -12.3732 +4706 4 11.9701 16.4097 33.1768 -13.251 25.8897 -21.4653 +4707 6 21.3776 37.3784 27.9508 -6.73969 12.2577 23.3137 +4708 4 21.2203 37.3231 27.0262 1.16773 -1.52428 -34.5533 +4709 4 20.718 38.0458 28.2038 6.71566 -1.73666 8.03222 +4710 6 27.2299 40.8388 28.8031 2.48401 0.937021 1.60569 +4711 4 26.5367 41.5089 28.9565 6.65702 -12.2841 2.86921 +4712 4 27.4065 40.3185 29.6035 -12.9999 8.55112 -0.224288 +4713 6 0.993205 21.7261 13.5372 -53.3037 2.48171 -36.3839 +4714 4 1.86429 21.8093 13.8237 52.7771 -6.56786 29.3883 +4715 4 0.417346 21.4203 14.2472 8.63216 3.11646 10.526 +4716 6 22.3067 2.58146 8.73662 29.448 -13.2509 35.6107 +4717 4 22.9722 3.05705 8.24165 5.16658 9.50374 -8.2335 +4718 4 21.5154 2.5876 8.23764 -24.8297 4.23497 -21.3736 +4719 6 29.9953 17.8456 8.24313 -2.433 8.62767 -9.90081 +4720 4 29.054 17.6713 8.30654 -5.44558 -4.70631 2.21427 +4721 4 30.3746 17.4275 9.01982 5.69521 -3.15286 8.62416 +4722 6 3.62819 37.7118 25.7099 -17.1271 -24.8271 -10.3244 +4723 4 4.40422 37.1524 25.7956 9.9921 4.76654 4.66524 +4724 4 2.941 37.0477 25.4485 4.12723 25.8155 6.09629 +4725 6 26.809 27.648 36.3589 -37.7802 -17.2474 29.8166 +4726 4 26.8014 28.1831 35.5758 -1.13827 16.217 -13.4241 +4727 4 25.8725 27.5642 36.7259 28.3017 7.35189 -21.1707 +4728 6 13.3559 25.3099 38.116 1.93465 -14.8526 16.0582 +4729 4 13.2959 24.3789 38.4372 3.98877 20.6101 -4.99041 +4730 4 14.1146 25.694 38.605 -5.66874 -3.07699 -9.11419 +4731 6 49.7048 27.2599 6.72622 -1.43928 22.3256 -10.7839 +4732 4 49.6686 26.3369 6.45132 -5.99645 4.70457 -4.8273 +4733 4 49.2845 27.8697 6.04945 8.54794 -27.7312 19.0533 +4734 6 39.7449 11.5776 10.1987 6.84991 -8.95817 -1.04181 +4735 4 40.3059 10.8428 9.86803 -8.86198 19.4731 1.33094 +4736 4 39.0907 11.7833 9.50723 6.52335 -1.56097 1.75374 +4737 6 17.4857 24.9907 35.5559 -11.6728 -0.232318 -1.23817 +4738 4 17.2359 24.7743 34.6481 -9.71541 0.96097 3.2925 +4739 4 18.4326 24.9281 35.5495 18.729 -4.76527 0.24637 +4740 6 45.0886 34.9858 31.8393 -13.7853 -2.59791 -12.3576 +4741 4 44.2542 35.4282 32.0247 4.31579 11.0194 10.5125 +4742 4 44.8031 34.4855 31.0733 13.3341 -13.9746 -4.20839 +4743 6 30.2109 9.89077 31.3202 8.39813 20.0527 10.0978 +4744 4 30.4343 10.7522 30.9233 -1.69236 -11.2354 5.34707 +4745 4 30.0976 10.0887 32.2697 2.61193 -8.5831 -6.90929 +4746 6 32.3748 9.22464 6.61109 37.8815 -39.2378 -50.8405 +4747 4 32.2118 8.68084 5.76454 4.57858 20.451 35.1159 +4748 4 31.5433 9.4233 6.96427 -45.6188 15.529 19.6617 +4749 6 9.26845 24.9782 35.9229 1.19564 -9.02769 -15.4958 +4750 4 8.9564 25.4582 35.1216 5.49795 -4.99978 19.1154 +4751 4 9.87718 25.5584 36.4061 -8.42028 -2.10732 -11.5846 +4752 6 40.3335 1.48296 18.8902 20.9136 0.652934 -58.3414 +4753 4 39.6207 1.94237 19.2768 -32.228 11.5513 31.9135 +4754 4 40.836 0.952532 19.4949 5.43911 -12.9068 21.333 +4755 6 5.27733 10.6166 30.4293 -4.37857 29.6514 35.8012 +4756 4 5.00531 11.4476 30.0112 -0.880507 -1.63534 -8.13264 +4757 4 5.35863 10.9185 31.3957 -0.759826 -20.4729 -25.7258 +4758 6 25.6655 11.6994 25.6535 -15.8411 -39.3949 6.40341 +4759 4 25.8392 12.448 26.1908 9.94197 23.9877 11.5846 +4760 4 25.8146 10.9427 26.2759 4.01869 23.17 -23.7809 +4761 6 21.9208 20.0736 29.783 -0.661059 -23.1285 25.9828 +4762 4 22.5528 19.9674 30.5279 -9.0028 12.6586 -11.845 +4763 4 21.4796 19.2024 29.7633 3.30396 8.80601 -15.8778 +4764 6 10.0031 19.9894 34.5062 10.0701 -18.9504 -1.84201 +4765 4 9.43917 20.4787 35.093 -9.85162 7.82768 6.06887 +4766 4 9.97528 19.0642 34.823 3.96148 11.1077 -9.79004 +4767 6 24.6395 10.3611 12.2013 10.4056 19.7725 40.7349 +4768 4 24.7062 9.53294 12.699 -2.91134 1.50973 -12.3578 +4769 4 25.0089 11.0108 12.8733 -15.5791 -20.8054 -25.2752 +4770 6 50.4386 28.2959 11.551 52.3964 -11.4141 -41.8896 +4771 4 51.2944 28.7096 11.1811 -37.3824 -15.4271 20.8858 +4772 4 50.1484 28.8694 12.238 -9.02874 19.1251 18.783 +4773 6 13.9255 27.6321 25.0575 -30.7043 9.27758 -16.9407 +4774 4 13.4685 27.961 25.8505 6.53671 1.50814 -8.33226 +4775 4 13.405 28.0084 24.2853 19.6442 -13.6277 24.9436 +4776 6 46.1675 18.6723 40.4127 -24.7255 0.52235 -5.51451 +4777 4 45.2163 18.6287 40.1471 17.8616 -3.70574 0.193046 +4778 4 46.2526 19.5549 40.792 -2.63441 -2.56699 -8.45512 +4779 6 32.4875 14.1744 27.1342 -20.1773 -0.115465 -0.458595 +4780 4 31.894 13.6021 27.6676 10.0212 10.5514 -7.27374 +4781 4 32.1329 15.0809 27.2203 4.74838 -8.22403 2.71507 +4782 6 14.0641 36.351 13.3878 -9.69625 43.6715 -7.48797 +4783 4 14.0645 37.3444 13.3555 12.262 -25.9465 20.9036 +4784 4 13.2835 36.2347 12.8457 -5.28255 -22.0231 -7.64651 +4785 6 1.89477 36.5899 21.9857 -12.7075 -7.68583 0.53673 +4786 4 1.75133 36.5712 22.9388 2.01013 -3.06644 8.01032 +4787 4 2.81569 36.8315 21.8421 3.36212 -1.19737 0.805445 +4788 6 25.2943 31.8607 39.7417 -2.48011 0.614033 34.0265 +4789 4 24.999 32.7283 39.4716 -5.73903 6.77443 -6.35095 +4790 4 25.461 31.9431 40.7124 0.191009 -4.33082 -23.8473 +4791 6 6.4797 22.0186 1.29894 -12.0535 -14.7769 -6.17691 +4792 4 5.53353 21.8063 1.36197 11.0348 5.26157 5.70773 +4793 4 6.5732 22.8347 0.80957 1.58971 11.8894 0.78955 +4794 6 27.6266 25.0275 4.69979 7.76412 30.8855 29.066 +4795 4 28.5017 25.4862 4.66738 -16.9061 -15.4428 -5.02391 +4796 4 27.2115 25.3905 5.52919 8.95609 -10.8934 -21.2922 +4797 6 21.6474 30.9429 41.2213 -14.674 16.9935 -31.5335 +4798 4 21.3077 30.3434 41.8509 -10.7705 -24.5884 29.0962 +4799 4 20.9035 30.9616 40.5667 22.5963 5.39714 5.21952 +4800 6 32.3503 18.8691 12.7728 -7.52429 -0.383917 -18.241 +4801 4 31.3918 18.9773 12.8161 6.27066 1.36054 6.85895 +4802 4 32.4619 18.5656 11.8564 12.6246 0.663961 8.91714 +4803 6 35.6352 19.4593 21.1461 -10.1734 29.4522 17.7801 +4804 4 35.3511 18.62 21.5049 -2.07097 -11.6796 -4.30053 +4805 4 34.9906 20.1214 21.5255 16.9121 -20.2959 -15.2058 +4806 6 27.6974 17.9478 34.0105 3.72497 22.7808 11.4532 +4807 4 28.1244 18.3695 33.2449 -3.6365 -3.33971 3.70746 +4808 4 28.0134 18.5196 34.7467 -3.33496 -14.4526 -11.1074 +4809 6 34.1722 39.0415 14.8025 -0.588556 -5.09353 50.87 +4810 4 33.8492 38.3378 14.2426 -9.69809 -4.78927 -2.35124 +4811 4 33.6075 39.0103 15.6476 14.9636 10.6202 -38.8415 +4812 6 28.5063 3.47722 33.8826 -13.8698 -21.2799 4.06498 +4813 4 27.871 4.20321 33.9085 6.20243 8.28698 -1.91661 +4814 4 29.4175 3.76621 33.9059 10.9167 16.0273 -3.84391 +4815 6 34.9231 32.1486 6.55347 -48.5451 -22.9266 3.43697 +4816 4 33.9921 31.9748 6.9467 49.872 11.9331 -17.2337 +4817 4 35.5478 32.1135 7.28146 1.17984 3.66225 6.53991 +4818 6 31.8923 6.87344 23.517 2.73099 13.3553 4.48118 +4819 4 32.4005 6.72509 22.7097 -0.163961 -9.68163 3.8586 +4820 4 32.2042 7.75277 23.812 -2.19309 -5.80853 -1.60196 +4821 6 18.8495 1.74691 0.846251 -10.8424 6.73855 -33.2301 +4822 4 18.128 2.12906 0.287715 7.30697 -5.37966 19.0723 +4823 4 19.1812 2.42034 1.43504 -3.90896 9.02122 12.2654 +4824 6 27.0029 18.9235 11.8738 61.7268 20.0146 -35.0636 +4825 4 27.2277 19.7644 11.4142 7.64396 -16.2258 9.71345 +4826 4 26.1059 19.0334 11.9849 -72.3018 -1.47246 20.779 +4827 6 43.8315 11.1413 18.4425 12.0955 7.77381 31.2403 +4828 4 43.582 10.9955 17.5403 1.6883 -14.8273 -19.2234 +4829 4 44.4878 10.475 18.7348 -4.89818 7.49251 -15.5557 +4830 6 33.4942 40.5585 37.6724 7.87983 -3.11064 16.6213 +4831 4 33.9456 40.2455 38.4765 5.57637 6.44045 -9.71494 +4832 4 32.6057 40.2384 37.8499 -11.5443 1.61602 -9.31227 +4833 6 15.6218 26.7049 39.4143 -33.8245 -53.4627 11.7102 +4834 4 15.4245 26.9754 40.2985 -0.693124 5.44593 20.3253 +4835 4 16.1216 27.3809 39.0562 36.6223 43.7441 -31.7418 +4836 6 4.38199 13.876 40.8778 6.07973 -11.0772 -3.70535 +4837 4 5.33347 13.6897 41.0138 -14.6737 -0.272428 -1.39073 +4838 4 4.02273 13.2235 40.2449 7.64869 11.7946 8.98025 +4839 6 20.1779 10.396 38.2135 -21.4206 4.43784 1.78325 +4840 4 20.3564 10.9148 37.4134 10.9013 -11.3706 0.559506 +4841 4 20.991 10.2443 38.6984 6.99273 1.77474 -1.94206 +4842 6 15.1578 19.2491 23.8705 6.70925 0.197906 -4.49513 +4843 4 15.3523 20.1614 24.134 -1.79925 -4.44488 8.10361 +4844 4 15.0598 19.3463 22.9079 -1.20619 -5.61783 14.9214 +4845 6 47.881 28.6148 15.8048 16.8356 22.7469 11.8397 +4846 4 48.0602 27.74 15.4965 -2.52866 -23.0751 -5.40804 +4847 4 48.6281 28.8091 16.402 -10.5906 -5.01786 -6.93826 +4848 6 29.925 30.905 18.9707 11.7406 3.33263 -1.10353 +4849 4 29.0879 30.4807 18.764 -8.84985 -7.33813 -1.92291 +4850 4 29.807 31.8375 18.7873 -6.04184 4.11832 2.37084 +4851 6 11.9324 35.8064 28.512 -27.4265 24.0258 -21.7564 +4852 4 12.5706 36.1347 29.1334 15.2736 -4.81493 21.8335 +4853 4 12.2236 34.9831 28.145 8.79196 -20.6768 -0.490374 +4854 6 29.967 37.8624 25.4885 4.59009 -4.14727 -0.313094 +4855 4 30.2605 37.0012 25.8228 -4.78695 -0.224547 -14.1967 +4856 4 30.4431 38.4647 26.0537 0.190265 15.5785 7.27405 +4857 6 52.6385 28.1101 32.2696 27.4129 -14.0906 14.429 +4858 4 52.1837 28.8064 31.8018 1.35463 13.918 -3.63194 +4859 4 53.5572 28.4115 32.4361 -8.8806 -0.527566 -10.0859 +4860 6 37.0194 40.0856 11.9811 12.8522 -14.0915 -8.99985 +4861 4 36.2698 40.6335 12.1547 -20.3135 9.86443 5.11387 +4862 4 37.3206 39.8255 12.8594 7.06858 1.59634 4.17732 +4863 6 16.6823 16.7862 36.5016 -40.0159 24.4695 -22.7659 +4864 4 15.9639 17.4464 36.7433 30.1481 -22.6997 -3.51596 +4865 4 16.709 16.8774 35.5181 2.88256 -1.64708 20.873 +4866 6 28.0056 4.17661 38.8341 -15.1907 4.44859 15.1459 +4867 4 28.8664 4.34511 39.2253 10.7528 -1.70638 -4.98709 +4868 4 28.1362 3.72531 37.9969 -2.54795 -6.06729 -7.91519 +4869 6 28.9121 0.2613 17.7196 11.2429 43.6022 -6.13696 +4870 4 28.206 0.913023 17.5432 1.57334 -10.0134 0.986336 +4871 4 28.5175 41.3357 17.883 -22.7122 -29.353 3.51833 +4872 6 22.9275 20.1119 26.272 10.3141 -17.1908 1.54721 +4873 4 23.597 20.0083 26.9758 -6.33812 5.26805 -6.32666 +4874 4 22.343 20.8217 26.5441 4.5912 8.26641 6.04785 +4875 6 49.4104 29.8887 13.4211 -27.0365 40.5227 7.20695 +4876 4 49.0994 30.824 13.2506 14.963 -27.7355 -0.582388 +4877 4 48.6865 29.5209 13.9525 8.18699 -4.12202 2.86767 +4878 6 2.45827 24.8307 7.29137 -22.8365 1.45709 37.207 +4879 4 2.32025 24.5445 8.23446 11.0976 11.5137 -22.649 +4880 4 1.77037 25.516 7.1857 7.09177 -11.7652 -6.70138 +4881 6 30.3948 26.4611 14.3404 -21.8067 20.3233 2.80707 +4882 4 31.1122 26.3224 14.9982 -12.4575 10.0222 -1.69757 +4883 4 29.8137 27.2743 14.5309 34.7851 -33.9666 2.2264 +4884 6 27.0321 32.5068 3.14827 -14.3662 17.1598 1.60641 +4885 4 26.4039 33.1156 3.62616 22.1531 -16.0826 -13.2832 +4886 4 27.3831 31.9163 3.82559 -1.71579 -4.01879 3.19031 +4887 6 34.2634 14.7959 1.27313 2.99828 -7.05923 -10.0889 +4888 4 35.1835 14.4352 1.19997 -20.4533 4.23129 -4.55267 +4889 4 33.713 14.3258 0.588346 24.9828 8.52884 21.9593 +4890 6 30.022 8.54163 1.32868 -10.2939 -13.069 16.6852 +4891 4 30.0052 9.45247 1.0409 -5.08902 11.4157 2.73646 +4892 4 29.2496 8.43498 1.92915 15.9692 5.13326 -10.6744 +4893 6 42.5647 11.5185 27.7103 -4.68909 6.08661 -3.61857 +4894 4 42.216 12.3928 27.8946 9.09127 8.642 -2.18095 +4895 4 41.8714 10.9656 28.0604 -6.00702 -16.6262 4.78299 +4896 6 52.461 39.5492 17.8365 12.2605 -26.0754 -32.0817 +4897 4 51.7553 39.7908 18.3861 -39.7898 9.50592 28.6027 +4898 4 53.1226 40.1801 18.0155 30.5873 23.5517 5.0779 +4899 6 33.2136 4.91918 31.6183 -6.56942 36.6821 16.923 +4900 4 32.9061 5.86322 31.5606 3.78329 -26.1329 5.01225 +4901 4 32.8884 4.48208 30.835 -2.61462 -3.20134 -11.4125 +4902 6 6.2936 16 18.7476 -12.5252 7.31014 22.9936 +4903 4 5.79227 16.5246 19.4216 24.8679 -4.64947 -16.2991 +4904 4 5.64136 15.3462 18.514 -6.08951 -9.62478 -9.34051 +4905 6 8.52033 14.5365 24.6875 -9.84601 3.26611 -2.01077 +4906 4 9.36791 14.3624 25.0978 6.86066 0.30113 1.47813 +4907 4 8.18366 13.6846 24.3866 1.77672 -1.96336 3.84573 +4908 6 22.6911 10.1297 32.1351 -27.5214 -52.5729 10.3709 +4909 4 22.3884 10.9899 32.3649 2.47289 32.4289 -2.22619 +4910 4 23.5203 10.1223 31.6812 20.4751 21.0076 -14.9216 +4911 6 11.292 2.12704 14.679 -26.9964 -14.1635 0.457424 +4912 4 10.3004 2.01295 14.5746 25.662 7.6895 -7.09692 +4913 4 11.7079 2.38272 13.8392 -0.157448 -3.91762 -7.39795 +4914 6 44.9096 15.591 36.2717 33.6405 -1.91298 -30.8875 +4915 4 45.0764 15.4828 35.303 -3.33411 7.1012 27.4883 +4916 4 43.99 15.446 36.3379 -31.2371 -2.78707 10.2167 +4917 6 9.72465 19.0179 31.2227 19.6005 -24.8416 -16.8371 +4918 4 10.5897 19.4265 31.3159 1.30764 -1.40065 3.11778 +4919 4 9.11252 19.5759 31.653 -23.8989 17.913 16.8503 +4920 6 51.9714 7.58847 16.6881 21.0297 -20.8952 -55.8985 +4921 4 52.6598 6.90966 16.567 -10.1825 8.15334 22.1112 +4922 4 51.6538 7.5728 15.7392 -8.87714 21.5211 34.751 +4923 6 31.4317 34.7753 36.422 -0.942044 -9.40807 -31.2122 +4924 4 31.7249 34.7672 37.3268 6.30465 10.9632 14.3566 +4925 4 31.2441 35.6593 36.0754 6.17504 10.5044 11.3925 +4926 6 4.22663 15.0937 15.3657 -12.9272 -11.1361 22.285 +4927 4 4.10058 14.8824 16.3208 1.18356 5.05287 -17.269 +4928 4 5.17453 15.1773 15.2713 12.4851 5.61025 -4.39011 +4929 6 47.7531 20.6767 28.0224 11.2198 -3.02063 -12.9376 +4930 4 47.6925 19.771 27.6598 -2.10862 13.919 9.51432 +4931 4 48.3916 21.1163 27.4231 -12.1395 -0.81062 10.3277 +4932 6 15.815 1.15165 24.4078 -58.142 17.9603 -16.0616 +4933 4 15.2825 0.557615 24.9446 12.6892 -15.3828 1.22604 +4934 4 15.0545 1.63036 23.9524 41.7436 -8.72437 9.7488 +4935 6 34.5811 39.7067 40.0776 25.1973 35.6425 -42.1699 +4936 4 34.2041 40.3093 40.7031 -18.6223 -6.05265 24.4589 +4937 4 34.3171 38.8242 40.1905 -21.7766 -38.3424 16.3885 +4938 6 20.1959 32.1778 34.4064 -21.1308 28.8301 22.4919 +4939 4 19.7756 32.8897 35.0113 13.9702 -37.934 -23.8567 +4940 4 21.1121 32.1056 34.6926 -2.59197 2.17732 9.39736 +4941 6 19.2966 38.5284 11.8437 26.0429 16.0259 -0.414132 +4942 4 19.2747 37.5954 11.9891 -3.91225 -17.7096 3.53088 +4943 4 20.0654 38.8356 12.3915 -17.5462 -2.40166 -9.14392 +4944 6 6.53181 13.5016 26.8314 -26.032 48.4544 -13.2533 +4945 4 5.96734 14.0602 26.204 31.1233 -23.713 24.7575 +4946 4 6.50803 12.6321 26.4707 -0.853216 -24.803 -10.5103 +4947 6 23.5899 31.5666 33.3383 5.98922 -6.50638 -9.93577 +4948 4 23.0479 31.6137 34.1308 1.15429 -4.79335 1.92272 +4949 4 23.6428 30.629 33.0606 -7.31668 7.17491 0.194963 +4950 6 41.0566 31.9249 16.2102 56.5158 -30.8904 -22.4873 +4951 4 41.9283 32.0344 16.659 -25.525 5.07155 -0.752829 +4952 4 41.3339 31.2779 15.4895 -19.0587 21.5349 12.1439 +4953 6 31.7523 18.8667 19.3593 3.35741 25.414 0.712525 +4954 4 32.0759 19.7269 19.7383 -8.81617 -22.0304 -12.3923 +4955 4 31.2718 18.4298 20.0739 7.05067 -2.94537 3.38628 +4956 6 10.4941 4.11052 19.3414 6.42456 29.4713 -33.6332 +4957 4 9.72315 4.57262 18.9428 7.32966 -14.5804 7.11 +4958 4 11.2095 4.33965 18.6811 -15.5987 -11.1936 33.5314 +4959 6 1.36933 32.4682 19.2841 21.0988 -14.4161 24.2075 +4960 4 2.01529 31.7231 19.2122 -13.2253 9.85044 -10.2965 +4961 4 1.01532 32.721 18.4367 5.36339 -4.1954 -20.4987 +4962 6 42.8687 16.8583 24.9978 45.6636 -43.4462 -50.5941 +4963 4 42.5079 17.7172 24.9824 -17.3855 32.283 0.331695 +4964 4 43.4322 16.7911 24.1362 -30.0172 8.55702 44.8961 +4965 6 45.317 19.181 4.10785 3.8422 34.8536 -4.15721 +4966 4 46.019 19.8398 3.89275 -2.03222 -14.2005 10.5278 +4967 4 44.6424 19.7199 4.5744 3.59127 -10.0852 -3.22755 +4968 6 29.1417 19.8939 35.7514 6.11075 -32.58 -16.2332 +4969 4 28.6926 20.3067 36.4515 -23.9686 13.1333 31.3988 +4970 4 29.2427 20.5957 35.1143 7.28783 5.32225 -12.4577 +4971 6 31.9564 21.8498 19.6592 2.82401 14.2352 -0.350828 +4972 4 32.7548 21.9543 19.0677 -31.5105 -7.28354 24.2009 +4973 4 31.6217 22.7614 19.848 10.5207 -20.3739 -6.13763 +4974 6 39.1981 8.2717 18.8284 -32.9061 14.1933 0.428726 +4975 4 38.9624 7.35629 18.6463 1.07118 -6.83808 -1.96228 +4976 4 38.3348 8.76709 18.6863 31.0345 -14.9445 1.78619 +4977 6 33.2818 13.2775 41.2684 -13.2208 -33.3764 1.31987 +4978 4 32.393 13.5626 41.0006 -3.83673 2.91025 7.56978 +4979 4 33.1808 12.3338 41.5845 5.22215 22.8712 -2.04361 +4980 6 5.9413 29.5498 35.797 -32.456 -34.3071 -6.72563 +4981 4 6.35963 30.284 36.1739 22.861 33.0715 10.0739 +4982 4 6.49565 29.1835 35.1072 8.32337 2.91553 -5.44074 +4983 6 13.0321 34.2086 31.915 -24.835 -40.2345 36.8573 +4984 4 13.0272 33.4084 31.376 1.88868 -0.760633 -7.07942 +4985 4 12.5489 33.9041 32.737 18.271 18.5714 -18.1292 +4986 6 33.9591 21.7903 18.011 18.8454 -21.734 -8.71067 +4987 4 34.7458 21.1933 18.012 -16.5142 3.18134 2.17277 +4988 4 34.2934 22.6573 17.8484 16.983 20.6817 -10.003 +4989 6 35.9748 41.3385 18.1559 -11.3515 0.0380054 -35.3696 +4990 4 35.8093 41.5204 17.1769 9.12346 -12.4659 34.6458 +4991 4 36.6045 0.098617 18.3947 7.40652 10.177 5.52403 +4992 6 34.8515 37.6574 30.5934 11.7527 -35.7483 27.3047 +4993 4 35.1492 36.8608 30.1169 2.57906 15.2804 -10.7791 +4994 4 34.9371 37.33 31.5271 -8.43612 19.6249 -16.9201 +4995 6 26.002 34.4146 4.67279 -8.48904 3.78898 9.19231 +4996 4 25.4415 34.5852 5.42871 -16.9308 -4.98482 2.97274 +4997 4 26.7915 34.86 4.9592 18.7282 4.65341 -5.76761 +4998 6 19.0552 33.5605 1.32358 6.49267 31.5074 -37.6332 +4999 4 19.8139 33.1288 1.70335 8.38847 -12.1483 9.88993 +5000 4 19.4402 34.1326 0.589952 -11.7405 -21.1797 25.0755 +5001 6 25.2648 8.23393 8.59155 9.31521 -3.65292 19.8467 +5002 4 25.4875 8.13778 9.5404 -3.07709 1.08931 -10.3145 +5003 4 25.4314 9.16241 8.38927 -1.28134 -0.00667841 -6.07783 +5004 6 12.8479 19.6935 13.0483 24.3757 5.37981 -4.8091 +5005 4 11.9603 19.9957 12.9501 -28.6845 1.86907 1.18076 +5006 4 13.3523 20.516 12.8959 -4.89806 -16.374 -0.906345 +5007 6 53.3502 11.4299 5.80806 17.1624 -7.42289 17.7098 +5008 4 53.8461 12.0471 6.36061 9.49207 -4.93163 0.0376 +5009 4 52.6392 11.9481 5.49246 -25.6427 10.4986 -14.7278 +5010 6 9.84876 16.0411 31.2026 18.9205 20.8399 7.27663 +5011 4 9.06508 15.7062 30.7868 -18.8641 -2.54228 -13.3824 +5012 4 9.84527 17.0253 31.1624 -7.05614 -14.0763 0.861631 +5013 6 25.427 20.2931 3.30062 11.4464 23.222 26.9187 +5014 4 25.5454 20.7694 4.15249 -9.33169 -17.4988 -10.5652 +5015 4 25.6323 21.0333 2.7154 -3.32412 -15.1122 -12.6987 +5016 6 20.7611 8.20749 15.6389 12.285 -44.7943 -30.6071 +5017 4 20.4521 8.55687 16.4556 -20.4937 3.03897 24.5457 +5018 4 20.4185 7.27697 15.5079 3.31214 29.403 13.2982 +5019 6 37.6491 8.60321 9.97383 13.4411 2.14626 39.4708 +5020 4 37.9762 7.71523 10.2023 -7.3296 7.95364 -3.74733 +5021 4 37.281 8.55077 9.10696 -2.37522 -5.79058 -16.8845 +5022 6 50.6587 4.51935 24.2622 -13.5896 -19.0591 8.29097 +5023 4 49.9232 3.87067 24.2726 8.09814 12.5004 -4.89174 +5024 4 51.4381 3.99879 24.4754 4.23299 2.4676 7.18675 +5025 6 20.1738 24.8175 34.9087 -20.6162 39.8894 -22.5586 +5026 4 19.8889 25.4664 34.1955 11.6566 -19.5752 19.2833 +5027 4 20.4138 24.0094 34.4666 -0.241841 -16.354 -5.00311 +5028 6 30.5812 22.5243 11.2258 -36.8716 21.596 38.6978 +5029 4 31.1688 21.9929 10.7494 35.9784 -15.9007 -22.5785 +5030 4 31.0799 23.2498 11.6175 0.71333 3.79074 -7.65826 +5031 6 17.3246 40.781 8.03002 -31.7256 21.6985 11.3561 +5032 4 17.3609 40.073 8.69249 8.70624 -3.14378 -12.3263 +5033 4 18.1517 40.9293 7.58873 21.0517 -16.9909 -7.06703 +5034 6 23.9551 41.0422 26.0635 49.9815 4.82526 35.6353 +5035 4 24.3667 40.5978 25.3173 -4.54613 -3.84774 -13.2149 +5036 4 23.0402 41.1884 25.9461 -38.539 -4.36769 -14.447 +5037 6 9.79432 25.5848 27.2203 6.65484 -20.1236 -27.319 +5038 4 10.0774 24.9678 26.4912 -4.54744 21.2611 22.5851 +5039 4 10.2742 25.3181 28.0139 -2.97183 -5.43805 2.20583 +5040 6 35.2559 29.8148 24.7567 4.66903 26.9266 -5.93859 +5041 4 34.3843 29.755 24.359 -8.51564 -12.4096 -2.57191 +5042 4 35.4992 30.7322 24.5163 3.09853 -9.53322 8.65044 +5043 6 2.14554 4.24448 10.5593 -22.2482 14.7122 10.1934 +5044 4 1.71214 4.34677 11.4486 21.0071 -10.277 -13.7719 +5045 4 1.55235 4.73342 9.96914 3.10164 -3.012 2.95666 +5046 6 43.1737 3.93442 23.504 -19.8173 -22.9925 0.828755 +5047 4 43.8868 4.03822 22.8829 13.7397 8.75634 -8.56433 +5048 4 42.5624 3.30318 23.0634 7.12322 11.7882 3.68849 +5049 6 18.8936 22.6308 2.43475 37.4693 -11.6119 5.39147 +5050 4 19.8359 22.2985 2.41568 -31.8063 3.38645 -2.45846 +5051 4 18.7431 22.7947 3.37318 -4.67781 1.83629 -1.28906 +5052 6 20.5039 18.9394 41.5502 -45.0653 -1.00263 50.2155 +5053 4 20.0478 18.6838 0.506021 30.3651 -1.16827 -32.2456 +5054 4 19.9073 19.6506 41.2865 12.7012 -1.26976 -15.3796 +5055 6 26.407 7.54687 29.1121 1.4357 2.47637 1.41449 +5056 4 25.6724 7.10479 28.6297 19.9382 8.96422 9.98625 +5057 4 27.0918 7.77745 28.4582 -11.2115 -7.41118 6.83701 +5058 6 25.6474 35.5684 33.7551 28.3954 -27.4775 -24.9773 +5059 4 26.3573 36.1942 33.5448 -9.56627 7.56335 10.8035 +5060 4 25.9974 34.7724 33.2466 -29.6941 19.0168 23.1671 +5061 6 24.829 0.49304 8.41898 49.9168 25.8876 59 +5062 4 25.5758 0.370102 9.1289 -47.1903 5.46774 -40.7742 +5063 4 24.7798 41.5674 8.0141 -4.73142 -31.3088 -22.2887 +5064 6 17.0191 17.3177 3.44507 -46.3903 19.7373 51.2207 +5065 4 16.2469 17.9517 3.64762 33.8447 -23.651 -21.8207 +5066 4 17.1185 16.9245 4.35427 5.98982 5.76213 -27.3591 +5067 6 40.1787 32.0965 19.3495 -2.04197 44.459 1.39821 +5068 4 39.7315 31.3261 19.6693 2.08081 -28.8107 0.337304 +5069 4 40.9568 31.869 18.8472 6.84111 -19.9226 -1.15348 +5070 6 23.382 26.6945 6.30636 26.5913 52.1271 15.5788 +5071 4 24.0556 27.4456 6.44648 -17.1373 -33.2326 -1.34025 +5072 4 22.7142 27.1153 5.75328 -6.08389 -4.52619 -7.61988 +5073 6 28.6524 28.5085 1.41248 40.8971 -13.4399 -11.1281 +5074 4 28.8916 29.4207 1.30452 -22.1266 20.7664 -4.28256 +5075 4 29.5558 28.1704 1.18501 -32.1523 -8.03877 13.3744 +5076 6 12.0456 6.33448 14.0345 -15.8903 -34.4 -29.7535 +5077 4 11.2902 6.05291 13.4483 16.0844 18.9407 21.6686 +5078 4 12.7823 5.99392 13.4906 5.33453 16.7776 14.1371 +5079 6 20.1258 33.7078 32.0959 -18.1893 1.56867 -4.93457 +5080 4 20.1945 33.0222 32.7471 -6.29187 -8.74149 18.477 +5081 4 21.0272 33.8529 31.8657 20.6776 7.89431 -10.0095 +5082 6 12.0665 33.3691 34.5458 -17.2285 -56.0193 -22.1145 +5083 4 11.5086 33.8793 35.1106 -7.76206 16.4549 16.9315 +5084 4 11.5605 32.4987 34.4127 27.4292 33.0374 0.608769 +5085 6 6.00658 22.2666 25.0532 -19.3255 -5.39958 94.237 +5086 4 5.834 22.4197 24.1868 -9.01045 11.6196 -89.8037 +5087 4 5.17345 22.6031 25.4913 31.6285 -9.76338 -3.83253 +5088 6 28.8848 9.49767 11.035 16.7623 9.63116 22.4077 +5089 4 29.0495 10.2086 11.6768 10.1151 -22.3542 -11.392 +5090 4 28.083 9.83925 10.6889 -25.6685 -5.48517 -25.0151 +5091 6 25.9808 31.1499 24.8669 6.22835 -24.9986 7.12483 +5092 4 26.2942 31.9621 24.5011 4.31737 18.7644 -10.9339 +5093 4 26.6597 30.4768 24.6157 -18.0541 8.02771 8.13926 +5094 6 17.4051 22.6403 26.9653 -7.75883 36.9734 2.0054 +5095 4 17.2144 23.5004 27.4753 3.96627 -41.4428 -18.3441 +5096 4 17.5261 21.9375 27.6083 1.93016 -8.19761 6.25563 +5097 6 30.9714 17.6252 1.64088 21.0154 14.9482 37.3685 +5098 4 30.2059 17.6112 1.0839 -20.4324 5.80492 -14.3468 +5099 4 30.9516 18.4373 2.23396 3.22156 -25.7853 -22.8165 +5100 6 35.2764 9.72503 11.2414 -18.3895 -2.76749 -51.624 +5101 4 34.6551 9.56245 10.4589 20.7383 2.80865 37.1903 +5102 4 36.1302 9.43155 10.8742 2.68762 -2.05229 10.7544 +5103 6 12.0172 10.802 4.27563 -38.9121 -6.07101 -4.90761 +5104 4 11.4313 10.6374 5.04504 13.8247 1.49432 -7.40831 +5105 4 11.4074 10.5604 3.53263 22.811 5.33779 9.30002 +5106 6 52.9577 23.1313 7.67787 -9.3269 3.09364 -7.79077 +5107 4 53.8153 23.0871 7.22609 1.51949 2.98805 -1.25247 +5108 4 52.6879 24.0607 7.78743 10.5919 -6.87524 0.0783357 +5109 6 27.3762 5.80009 23.1013 37.771 37.8703 25.2466 +5110 4 28.2178 5.56094 23.5856 -32.2451 -1.57897 -13.9899 +5111 4 27.4704 6.79781 23.0764 -15.1432 -38.3322 -6.34326 +5112 6 22.7771 37.7063 15.5287 -6.89324 -10.2053 44.7861 +5113 4 22.8198 37.7465 14.5962 3.81902 5.91484 -35.4551 +5114 4 23.2903 36.9427 15.8415 -1.83068 2.7653 -4.67104 +5115 6 30.583 30.1381 39.7472 11.9278 5.78959 4.89923 +5116 4 30.1399 29.6129 39.0656 -4.27402 4.25284 -2.63349 +5117 4 30.6547 31.067 39.4612 -8.3831 -13.7724 -7.9353 +5118 6 26.5154 14.8633 29.9609 11.0831 -12.5589 -33.9006 +5119 4 25.6935 15.2477 30.2118 -18.1143 15.4408 19.147 +5120 4 27.1376 14.9035 30.6723 6.99544 5.71887 23.1856 +5121 6 9.52617 19.5446 37.4141 -27.8096 33.0225 -3.94279 +5122 4 8.56344 19.6819 37.5998 22.5694 -19.9005 4.13551 +5123 4 9.71087 20.3892 36.9619 8.68778 -16.8671 10.038 +5124 6 0.93064 14.8656 2.69338 -45.7679 -11.5139 71.6593 +5125 4 1.44105 15.217 2.01526 37.3122 25.2366 -40.5783 +5126 4 0.982855 15.4275 3.5214 11.2099 -15.0526 -29.9277 +5127 6 46.4291 27.1302 41.5927 44.8021 -5.11347 -18.4756 +5128 4 47.4269 27.1857 41.3316 -52.8753 -1.56841 10.8767 +5129 4 46.0453 26.5632 40.9031 3.09365 7.20255 7.14326 +5130 6 47.6703 23.0461 21.3817 14.1329 62.5249 18.4178 +5131 4 46.9615 23.2467 20.7836 -14.1781 -2.67912 -10.5965 +5132 4 47.8255 22.1376 21.4096 0.736735 -54.6337 -3.62162 +5133 6 39.861 22.2186 3.09273 14.3751 -13.6386 -17.8056 +5134 4 38.9812 22.2192 3.47284 -7.54245 -0.786418 6.90323 +5135 4 40.0217 21.2868 2.78929 -10.5756 29.8648 14.1337 +5136 6 14.9857 14.9315 33.4628 8.45923 30.4043 17.83 +5137 4 15.3946 15.8263 33.6275 -11.7248 -28.7506 -9.93609 +5138 4 14.5839 14.7058 34.318 1.67348 -1.86342 -8.89677 +5139 6 27.3225 11.4951 31.9326 -53.5602 -46.3542 13.457 +5140 4 26.8632 12.0627 32.5566 10.8872 8.4751 3.08438 +5141 4 28.1269 11.8297 31.6518 53.6341 36.944 -15.9306 +5142 6 36.7606 7.97817 7.63938 -5.6216 -14.483 -15.6739 +5143 4 35.961 7.43887 7.80711 8.78578 3.79539 -7.6162 +5144 4 37.414 7.37034 7.2323 -6.45073 3.96969 3.37374 +5145 6 49.4351 9.64395 18.2091 29.626 55.2849 10.866 +5146 4 50.1121 10.1978 17.7651 -9.80365 -29.4086 -13.348 +5147 4 49.2806 10.2909 18.9191 -22.4891 -21.6225 2.73598 +5148 6 27.0558 33.8708 10.7695 -35.2964 21.4972 9.63291 +5149 4 27.0077 33.3399 10.0051 13.5655 -23.8621 -34.587 +5150 4 26.1863 34.3133 10.6733 10.9844 1.63438 18.9088 +5151 6 11.1931 37.467 6.82672 4.88099 -16.6436 19.1561 +5152 4 10.8369 38.341 6.72067 -6.30082 13.8936 -5.38019 +5153 4 12.1372 37.6177 6.93955 5.33816 -5.06614 -4.03667 +5154 6 19.2682 19.4041 21.904 -23.2853 8.1035 46.9014 +5155 4 18.5523 19.4276 21.2977 -21.2798 -5.04156 -20.5384 +5156 4 20.0545 19.4439 21.4012 35.6905 -5.22778 -21.4405 +5157 6 54.5004 2.91828 22.5705 32.5661 -1.01917 48.733 +5158 4 54.2618 3.02388 21.6728 -2.16971 10.501 -40.9175 +5159 4 0.435524 3.25313 22.7695 -30.9494 -6.38648 -13.13 +5160 6 45.0599 10.868 24.2364 14.5135 -18.2796 4.13426 +5161 4 44.3635 11.4663 23.9664 0.226806 13.7258 12.1538 +5162 4 45.5813 11.1999 25.0017 -10.9868 0.331296 -15.4884 +5163 6 14.3917 34.4176 24.7766 -9.76404 -18.453 -6.38428 +5164 4 14.7761 35.2693 24.9957 4.99605 2.44674 1.2141 +5165 4 14.8449 34.0832 23.9904 0.575187 7.45256 -7.27956 +5166 6 50.5869 17.5623 4.30497 19.1488 -58.6727 24.3661 +5167 4 51.3501 17.8958 4.78847 0.670503 12.5806 -1.04554 +5168 4 50.1422 18.2474 3.88142 -19.7161 48.0777 -23.3625 +5169 6 14.9242 33.337 34.1076 -18.6172 33.5363 80.554 +5170 4 15.0808 32.9083 33.3321 11.226 -38.5345 -73.3592 +5171 4 14.0723 33.0217 34.4665 7.96171 10.4343 -9.42002 +5172 6 20.8631 33.5747 38.9135 21.2953 11.2024 -25.7312 +5173 4 20.865 34.0752 39.7143 -3.94121 7.45437 24.6588 +5174 4 20.36 32.7884 39.0656 -12.436 -21.6406 1.81461 +5175 6 7.7707 4.74963 26.7362 26.5342 -10.6541 19.1955 +5176 4 7.23261 4.91898 27.5026 -6.83786 10.9421 8.37469 +5177 4 7.15089 4.73593 26.0203 -3.95236 1.60233 -15.9617 +5178 6 9.2875 21.4887 22.2941 45.0197 -19.5209 20.7118 +5179 4 8.6739 21.9912 21.7696 -4.21454 15.1903 -23.2464 +5180 4 10.2572 21.6206 22.0058 -46.5259 5.6334 -2.177 +5181 6 20.5439 38.2154 8.85856 -11.8412 3.64647 49.7312 +5182 4 20.3505 38.5634 9.79035 9.75602 -4.66312 -40.2998 +5183 4 20.2844 37.2891 8.95048 10.2824 2.6457 -7.05014 +5184 6 30.1005 39.0839 30.7484 -12.1958 38.1552 23.9792 +5185 4 30.3724 39.9578 31.2326 -12.541 -45.9124 -25.2432 +5186 4 29.1103 39.003 30.8437 30.6219 6.07536 -1.13857 +5187 6 16.0462 22.036 24.5064 2.37861 -9.55962 -5.99251 +5188 4 16.6334 21.9741 23.7207 6.17482 7.89117 19.2285 +5189 4 16.5569 22.3155 25.2979 1.4399 -2.17025 -8.02685 +5190 6 5.74172 29.2061 14.4603 -14.7312 11.1013 -1.58992 +5191 4 6.41865 28.6839 14.8489 24.8954 -16.4528 0.429681 +5192 4 5.37542 29.618 15.2515 -13.4536 5.99623 -6.25212 +5193 6 28.0689 3.08071 25.2267 -3.20814 35.3244 14.901 +5194 4 28.6407 3.76435 24.8336 -2.36389 -14.401 -4.10269 +5195 4 27.6795 3.6106 25.9691 7.41152 -23.0621 -10.2478 +5196 6 45.9381 29.3111 31.4283 -35.5447 25.9568 9.82539 +5197 4 45.677 28.707 30.7493 2.31008 -18.1922 -21.3643 +5198 4 45.1265 29.9079 31.4744 34.4717 -15.8255 11.1052 +5199 6 11.2229 22.8376 36.7897 -1.27591 2.9175 -5.69903 +5200 4 10.6623 23.4314 36.25 10.4728 -5.78036 -0.0474996 +5201 4 12.0147 22.5841 36.2713 -9.37786 4.28983 5.66853 +5202 6 18.9444 40.1485 39.92 -15.471 -8.01044 2.33142 +5203 4 19.1439 39.1941 39.9507 -1.34087 5.25319 4.4419 +5204 4 18.8847 40.4877 40.8271 3.43659 -8.21326 1.76593 +5205 6 23.5503 26.0803 21.2869 1.98517 -8.46863 16.2364 +5206 4 22.847 26.649 20.9475 -0.393515 -5.32061 4.06564 +5207 4 23.2913 25.6403 22.1336 -2.29953 13.2014 -21.5927 +5208 6 16.8518 5.38834 15.8565 -25.8193 5.07215 -6.0744 +5209 4 16.3979 5.3834 15.0179 8.08064 -16.6857 -11.3384 +5210 4 16.3642 6.13153 16.2159 17.5374 8.90145 23.838 +5211 6 12.0293 26.6115 15.0052 48.8575 28.3431 -20.5386 +5212 4 11.753 25.9113 15.557 -22.1508 -25.2102 16.954 +5213 4 11.3677 26.9943 14.4309 -20.7091 -9.23994 -0.184726 +5214 6 14.3404 41.4231 2.37222 21.8802 31.2536 -15.2067 +5215 4 13.6639 41.0433 2.88545 -29.1815 -25.4177 23.2655 +5216 4 14.3137 0.446574 2.65591 6.04323 -12.5169 -2.89291 +5217 6 50.3994 35.8721 9.32148 7.74023 -5.00078 -0.0244409 +5218 4 50.7985 35.7097 8.44539 1.7624 12.9821 5.72804 +5219 4 50.9327 36.5364 9.8137 -9.76519 -8.88391 -14.7497 +5220 6 11.3732 22.6657 26.8674 13.5542 4.36995 9.37334 +5221 4 12.2226 22.4007 26.49 -3.86507 -2.48494 3.34128 +5222 4 10.7274 22.4174 26.2153 -14.8849 -5.84603 -9.40936 +5223 6 8.44501 34.5567 21.2657 -4.1178 -59.9386 7.63204 +5224 4 8.06567 35.1301 21.9247 -8.42944 2.78434 16.8569 +5225 4 8.10966 33.58 21.4462 13.1168 58.8803 -11.2866 +5226 6 9.4289 8.66253 24.4817 -31.3326 14.2813 -20.5935 +5227 4 8.45611 8.64572 24.2655 24.8039 10.7682 6.42659 +5228 4 9.52915 9.21836 25.2644 -0.461641 7.68001 5.20174 +5229 6 32.603 22.3274 34.5057 1.1064 -2.38466 -37.2003 +5230 4 32.4525 23.1707 34.0368 4.85154 -2.46017 7.68642 +5231 4 32.8396 22.5701 35.3818 7.58742 14.9461 32.9529 +5232 6 26.736 26.1837 7.12165 10.4716 16.8024 -17.1295 +5233 4 25.9537 25.8031 7.51207 -7.84415 -15.2109 12.7352 +5234 4 26.4604 27.1054 6.93432 8.77765 -19.2484 4.4957 +5235 6 34.0014 11.9295 3.96807 -3.56186 4.82634 5.33773 +5236 4 33.6494 11.5631 4.78494 7.3544 2.33703 4.85457 +5237 4 33.8594 12.8842 4.06904 0.478869 -2.08104 -5.13073 +5238 6 21.473 20.924 37.1992 5.8677 19.4674 12.3893 +5239 4 22.3242 21.3752 37.157 2.6693 1.87465 3.04951 +5240 4 21.708 20.0203 37.0255 -6.20277 -25.1527 -1.47337 +5241 6 18.4792 41.0219 0.672743 -35.2491 -25.3697 -26.4792 +5242 4 17.5363 41.1592 0.451811 6.2729 -6.09178 6.10687 +5243 4 18.7532 41.8934 0.847545 18.5165 37.9853 8.81983 +5244 6 41.3458 41.7141 25.1818 17.8335 14.8146 -1.57438 +5245 4 40.8444 40.9381 25.3951 -6.7286 -20.9895 5.67055 +5246 4 41.5773 41.6158 24.2546 -2.61686 2.51709 -2.2804 +5247 6 27.6337 28.128 3.93443 68.2433 49.922 -72.4808 +5248 4 27.747 28.0641 2.90056 -5.60951 6.59214 55.905 +5249 4 26.974 27.5707 4.19301 -60.7891 -51.6503 16.466 +5250 6 18.2766 10.5218 31.4985 31.6557 -13.945 -4.11948 +5251 4 17.4661 10.038 31.5755 -21.8827 2.32902 1.26527 +5252 4 18.1351 11.463 31.4681 -8.30794 8.79106 3.21692 +5253 6 11.3047 37.9513 14.7719 14.2766 22.5792 8.51892 +5254 4 10.8196 37.2524 14.3384 -3.55752 -10.2024 4.33151 +5255 4 11.8722 37.607 15.4977 -19.1201 -2.12261 -16.4117 +5256 6 0.810718 18.1323 27.5767 30.9572 19.3393 -0.702274 +5257 4 0.190255 17.4711 27.3024 -13.6082 -17.9307 4.12615 +5258 4 1.6652 17.6816 27.7433 -15.3641 2.36995 -0.952151 +5259 6 36.7957 10.7342 20.2882 16.9593 17.0847 7.18326 +5260 4 36.2525 10.0089 20.0111 -13.8544 -11.0907 -5.31633 +5261 4 36.5766 10.8708 21.2175 -0.466777 -2.92115 4.06643 +5262 6 47.4269 25.5204 8.035 -8.77625 7.04012 -26.0141 +5263 4 47.2351 25.672 7.07342 16.0738 -5.10236 26.6147 +5264 4 46.6031 25.1946 8.38488 -7.38433 -0.0309169 8.21918 +5265 6 13.9121 35.1279 15.9963 57.6206 21.904 15.8158 +5266 4 13.18 34.6338 16.2776 -41.6081 -30.4219 4.97616 +5267 4 13.8612 35.4714 15.1124 -11.7278 3.29634 -19.5683 +5268 6 29.56 35.3617 16.1847 -46.2751 8.28104 -14.7299 +5269 4 30.2098 34.9035 16.6971 16.3841 -9.08849 15.1595 +5270 4 28.6495 34.9755 16.3324 34.0842 8.73794 -6.93478 +5271 6 29.4892 25.8842 32.4194 -24.256 -10.4352 -29.1805 +5272 4 28.8256 25.7516 33.0892 -1.91161 2.59937 23.0953 +5273 4 29.0388 25.4531 31.6468 24.6149 5.96309 7.68736 +5274 6 24.1242 2.12171 25.4449 33.2745 25.8541 -21.7468 +5275 4 24.4973 2.84525 24.8288 -6.14236 -31.0627 26.9036 +5276 4 24.7925 1.39916 25.5361 -16.9688 12.032 -10.1501 +5277 6 4.54733 34.4389 19.1463 -35.302 -7.10976 -3.39284 +5278 4 4.35486 34.5879 18.2161 16.9971 0.874352 -7.12679 +5279 4 3.63202 34.4395 19.5005 25.743 -3.14875 11.9651 +5280 6 10.1206 17.2361 14.3164 8.36708 -29.6599 -28.3251 +5281 4 10.306 17.5039 15.1955 -0.106022 16.7729 24.4966 +5282 4 9.5035 17.8022 13.8616 -7.59249 10.3925 2.01091 +5283 6 21.4437 41.7724 34.6698 -12.6382 -8.67476 11.1219 +5284 4 21.3209 41.1297 35.367 19.1323 -10.7035 11.8578 +5285 4 20.52 0.052046 34.4982 -0.738196 4.11389 -17.598 +5286 6 36.1618 24.1149 12.6039 -38.5184 -29.276 -18.6614 +5287 4 35.5274 23.7914 13.2897 25.4622 4.78071 -2.2183 +5288 4 35.751 23.7447 11.7708 17.6549 15.9976 15.8112 +5289 6 49.5813 18.6026 19.9424 19.3655 4.31785 -3.79274 +5290 4 50.05 19.3681 19.5461 -11.4841 -9.87428 2.01803 +5291 4 50.2881 17.9408 20.0283 -8.44417 3.53865 1.64593 +5292 6 1.24663 7.05846 14.4912 39.2605 -25.8072 -27.0237 +5293 4 1.83321 6.85564 13.6734 -27.5618 7.792 37.3713 +5294 4 1.40902 6.33035 15.1313 0.69425 14.6008 -10.3474 +5295 6 12.7431 22.7725 31.2519 -28.0711 -22.2846 -24.537 +5296 4 12.731 22.0484 30.5842 -1.03989 14.4355 17.1556 +5297 4 13.6361 23.0601 31.2889 29.0982 7.61123 0.941905 +5298 6 8.17623 18.6217 27.8167 28.4831 -7.95646 -20.137 +5299 4 8.40342 17.6669 27.8028 -7.19499 14.8132 8.92302 +5300 4 8.90402 18.9943 27.2753 -13.5351 -1.9306 8.34595 +5301 6 52.1398 28.0368 15.3061 -5.99984 -2.63203 -6.56281 +5302 4 52.212 27.4921 14.5152 3.50742 -7.1981 5.43712 +5303 4 52.1344 28.9249 14.9274 -1.52971 -5.17654 6.68842 +5304 6 52.6974 21.8977 10.081 -19.9085 6.90605 5.3514 +5305 4 53.3388 22.3376 10.626 19.2735 6.64212 5.60719 +5306 4 52.8023 22.3165 9.21858 0.448532 -1.39229 -3.54893 +5307 6 22.3312 5.79987 2.67028 14.2956 -6.96789 22.7666 +5308 4 22.4342 5.66665 3.62826 -7.95027 2.50856 -4.24886 +5309 4 22.7763 5.02131 2.34757 -2.68692 -18.1597 -17.0707 +5310 6 15.4178 16.2178 21.8878 29.1139 16.3559 -34.9346 +5311 4 14.4763 16.1482 22.0206 -17.0561 3.51129 1.66656 +5312 4 15.5967 16.6295 20.979 -16.1676 -12.6325 35.129 +5313 6 28.6996 41.2944 33.8986 -0.299799 0.972013 4.01662 +5314 4 28.6528 40.5712 34.5346 5.69191 -6.81028 -1.89437 +5315 4 27.7925 41.4039 33.5788 7.00998 2.71453 4.16387 +5316 6 9.0271 31.2603 18.2166 -24.0632 3.5617 9.69965 +5317 4 9.00312 32.2249 18.3215 -0.833429 -0.795431 1.49639 +5318 4 8.39564 30.8695 18.8792 23.5138 4.17381 -14.686 +5319 6 20.5401 20.4009 18.1765 -9.82111 13.5354 -7.0052 +5320 4 21.0961 20.6619 18.9088 6.00228 -1.57494 14.3732 +5321 4 19.8969 21.1451 18.1138 9.42471 -20.4088 -2.28899 +5322 6 53.9632 14.7108 37.8185 38.9936 -13.777 37.4998 +5323 4 53.5065 15.4999 38.0588 -19.2143 21.2037 -5.62994 +5324 4 53.6553 14.2856 37.0504 -18.643 -5.89619 -29.3657 +5325 6 28.9005 15.3805 18.8553 43.4355 2.75939 -10.7082 +5326 4 29.8744 15.2601 18.5577 -43.1698 -4.30042 15.6378 +5327 4 28.8821 15.3937 19.8257 1.95554 -2.72042 -0.550014 +5328 6 2.00757 25.8231 18.9102 1.56834 13.1457 16.4238 +5329 4 2.16994 26.6099 18.3718 5.10623 3.14141 1.15535 +5330 4 1.76535 25.1325 18.3092 -5.75322 -15.1157 -18.9078 +5331 6 53.2586 40.7003 24.294 -3.95682 23.2035 5.10337 +5332 4 53.3627 39.7881 24.0333 10.577 -13.1769 -1.30533 +5333 4 54.0929 41.151 24.0537 -8.8009 -7.19084 1.91562 +5334 6 47.531 32.0044 22.8424 -9.22212 4.73076 14.8806 +5335 4 47.3777 32.6735 23.5302 -5.63931 6.65432 -9.88941 +5336 4 48.2144 31.4763 23.2497 9.41484 -5.26157 -3.09765 +5337 6 24.6289 26.1478 33.0175 -22.0968 -9.02062 -12.6011 +5338 4 24.4656 25.5474 33.7557 -1.10221 8.12594 5.97613 +5339 4 25.4283 26.6445 33.1202 14.9272 4.196 4.65224 +5340 6 21.3417 17.0876 39.4763 -6.70912 6.89414 0.748051 +5341 4 22.0272 16.5901 39.8927 14.9242 -9.38388 2.18929 +5342 4 20.9728 17.5957 40.2063 -4.43123 6.71259 -1.60026 +5343 6 11.0417 40.4515 17.0271 -4.84825 -47.9733 -31.3307 +5344 4 11.617 41.1325 17.3235 21.4854 16.9952 0.793724 +5345 4 11.529 39.8797 16.3454 -22.439 27.66 32.3414 +5346 6 20.3522 21.2696 39.8718 -25.2322 13.8952 23.2629 +5347 4 20.7065 20.9823 39.0558 13.3567 -12.8249 -34.1322 +5348 4 21.0787 21.2544 40.4999 1.2931 1.07094 1.93889 +5349 6 2.11891 29.6947 22.5962 -10.9271 -4.15175 -1.48688 +5350 4 1.41229 29.0196 22.6861 11.0269 1.69063 -12.8134 +5351 4 2.97173 29.2673 22.4434 -6.16143 -1.40449 -3.11444 +5352 6 36.756 30.301 35.4561 22.3149 -30.6991 6.56967 +5353 4 36.1659 29.9908 36.1617 3.98829 10.9575 -2.82389 +5354 4 37.5905 29.761 35.5884 -25.1141 24.4323 0.251817 +5355 6 12.9563 4.31922 37.9158 -41.9162 -7.49401 17.923 +5356 4 12.213 3.67486 38.0016 27.2031 5.98064 4.05536 +5357 4 12.5797 5.11915 38.3509 20.8388 -3.72048 -10.4757 +5358 6 38.3368 5.25882 18.4553 -27.9454 13.7946 -11.1943 +5359 4 37.494 5.12162 18.8921 -4.17763 4.09508 -3.9191 +5360 4 38.9486 5.03087 19.1262 32.9808 -9.34357 19.7422 +5361 6 10.4991 9.23341 21.7308 -20.3579 1.12747 21.1104 +5362 4 10.1476 9.35811 22.629 -2.53412 -6.58654 -7.03761 +5363 4 11.4429 9.27697 21.8681 13.0367 -0.194449 -11.5952 +5364 6 0.510441 41.039 17.3204 -22.411 45.8537 -1.19125 +5365 4 1.10275 40.3438 17.515 21.9532 -27.5034 12.6219 +5366 4 0.955429 41.8901 17.5577 -0.403404 -22.4144 -8.21181 +5367 6 4.11028 5.06714 6.43108 -32.0559 -10.673 -25.0156 +5368 4 4.76196 4.43778 6.68194 21.2279 -22.0503 -6.17775 +5369 4 4.3376 5.79555 6.94869 8.69612 42.0455 26.6358 +5370 6 11.4527 25.4042 0.173069 -8.87291 20.1751 -4.43043 +5371 4 11.3037 26.302 0.51034 -2.48968 -2.12098 1.34892 +5372 4 12.3912 25.256 0.330533 -7.09022 -12.0676 2.67745 +5373 6 7.43008 21.5598 8.10589 6.84767 -16.7382 -30.018 +5374 4 7.67559 21.2373 7.18738 -12.1375 12.6211 33.8068 +5375 4 8.24892 21.8626 8.52003 -6.07298 -1.72571 -6.46698 +5376 6 47.5896 16.3642 25.2431 -28.5582 13.6976 -25.6498 +5377 4 46.6075 16.1608 25.1822 37.2389 5.55574 -4.66364 +5378 4 47.8562 16.8152 24.3682 -3.16196 -14.4146 40.515 +5379 6 30.9292 19.5125 39.8483 -41.4217 8.94898 -20.4144 +5380 4 31.859 19.4188 40.0164 22.9308 8.40553 1.58818 +5381 4 30.7224 20.3633 39.3589 16.5857 -27.3682 15.8932 +5382 6 20.3871 24.0387 39.4036 8.00795 23.2793 -8.75093 +5383 4 19.459 24.1701 39.2693 -20.2994 13.2523 2.58474 +5384 4 20.4244 23.1071 39.4874 5.50164 -36.2952 5.14995 +5385 6 45.8871 21.2471 41.1655 20.5283 25.7578 0.477301 +5386 4 46.6385 21.2626 41.7552 1.12624 -15.6366 20.1575 +5387 4 46.1812 21.9667 40.5962 -14.858 0.0662744 -14.6758 +5388 6 32.5732 28.1983 30.4559 17.8923 -19.7368 14.2663 +5389 4 32.9661 27.3096 30.6426 -14.7491 22.8943 -8.37245 +5390 4 33.2232 28.8091 30.8453 -8.57676 -1.81844 -4.53088 +5391 6 18.0207 1.32021 27.0363 -34.7874 1.53884 20.0911 +5392 4 17.0721 1.60205 27.1202 27.3864 -5.2263 -11.315 +5393 4 18.3294 1.50373 27.9381 11.4124 1.84961 -11.8648 +5394 6 39.378 24.9761 21.8758 -21.83 -3.15726 3.51608 +5395 4 39.2925 25.9351 21.9975 13.0773 -1.30024 -1.60914 +5396 4 38.5262 24.6687 22.2439 10.6836 3.42961 -4.87158 +5397 6 33.5904 21.3057 22.0908 0.876878 23.3779 1.34154 +5398 4 32.7037 21.4589 21.7601 -6.64994 -10.6299 -4.35651 +5399 4 34.0298 22.1428 21.8479 4.87062 -13.8873 3.79153 +5400 6 40.1162 15.0006 15.7553 -16.7667 -72.1851 -56.1125 +5401 4 39.3246 14.5665 15.2764 38.6699 22.9899 20.5541 +5402 4 39.7685 15.7046 16.224 -23.0828 51.553 35.6364 +5403 6 32.7063 17.9241 6.36312 -6.65812 28.0098 -27.693 +5404 4 32.6631 17.3286 7.08836 -4.96405 -26.2659 23.6138 +5405 4 32.2202 17.5402 5.61621 0.349997 -9.22032 2.43078 +5406 6 50.4717 15.9308 31.1336 -57.0185 -34.1342 43.3708 +5407 4 51.2677 16.1483 30.7347 55.5832 16.4654 -29.6643 +5408 4 50.5499 15.0059 31.4683 -2.42192 20.1529 -11.8828 +5409 6 23.8292 29.3322 31.6407 10.3974 -8.56959 5.42825 +5410 4 23.7096 29.6981 30.7618 4.3803 -0.813234 -2.10966 +5411 4 24.6813 28.8378 31.6594 -15.3785 13.3689 -4.34977 +5412 6 25.0524 41.6477 38.2806 4.00174 7.46449 -31.3583 +5413 4 25.6511 41.367 37.5454 -10.3054 -0.491554 23.0497 +5414 4 24.5276 0.474703 37.8884 8.98972 -6.87862 14.9811 +5415 6 14.3299 25.4693 7.99598 -51.8246 -23.5651 26.6357 +5416 4 15.0301 25.7523 7.4663 39.147 18.3395 -31.3738 +5417 4 13.6749 25.0466 7.38907 19.2382 9.49844 7.52052 +5418 6 17.2117 20.7467 5.34291 -12.6959 30.9635 29.5807 +5419 4 17.5658 20.2645 4.6512 13.3362 -42.6322 -45.6451 +5420 4 17.6752 21.5763 5.21476 -4.76461 12.1014 12.8322 +5421 6 18.8578 10.961 23.7113 11.9098 -52.6755 14.4862 +5422 4 18.5821 10.3312 23.0139 -2.7304 18.9854 0.947207 +5423 4 18.7069 11.8432 23.4586 -8.32501 34.3086 -18.4054 +5424 6 7.80658 41.3805 11.0401 -9.04392 11.0606 6.15122 +5425 4 8.00429 40.5098 11.4059 2.67644 4.01258 -4.23655 +5426 4 8.51691 0.066 11.3394 -1.81513 -7.16892 -1.05394 +5427 6 48.6966 23.1832 34.0648 -27.3561 -6.76338 -18.0805 +5428 4 48.0792 22.9132 33.32 19.6766 11.2437 24.8207 +5429 4 49.5669 23.23 33.6693 11.2336 0.854645 -6.12438 +5430 6 53.7246 23.5588 15.3422 -2.2993 4.88061 -38.5045 +5431 4 54.0115 23.9686 14.4981 1.04624 9.96871 20.6807 +5432 4 53.2132 22.8493 14.9574 -7.54922 -9.79714 16.7607 +5433 6 22.2409 5.63035 9.83732 -4.74687 0.990813 -28.4051 +5434 4 21.8007 4.9012 9.36518 5.41421 2.33681 17.3637 +5435 4 22.5704 6.16354 9.07597 -3.08255 -9.23766 25.1176 +5436 6 33.6677 8.38805 9.07277 4.65141 2.45263 2.68713 +5437 4 32.9476 8.96499 9.32099 -11.143 10.7473 10.4723 +5438 4 33.4213 8.08448 8.2012 2.38155 -0.0587928 -10.5973 +5439 6 47.3188 37.7205 20.3441 15.215 11.7573 -25.0114 +5440 4 47.5704 37.5879 19.4187 8.2864 3.06637 8.88956 +5441 4 46.6261 37.0853 20.3703 -21.7602 -22.9037 19.9419 +5442 6 30.8605 16.7391 10.6102 -28.0995 -48.2853 23.2284 +5443 4 30.4428 17.1675 11.4048 8.00556 -5.70758 -17.8294 +5444 4 30.5213 15.7576 10.5828 6.17084 54.1408 -3.58748 +5445 6 48.1227 27.723 10.1192 -17.271 38.6552 19.8549 +5446 4 48.941 27.5885 10.6019 15.4404 -6.10886 -7.64033 +5447 4 47.9667 27.1056 9.42146 1.69339 -23.2576 -13.9441 +5448 6 27.3465 38.6397 25.5972 -19.3603 -43.7567 25.3821 +5449 4 28.2552 38.3171 25.6348 3.73027 6.4174 -6.06634 +5450 4 27.3175 39.4354 25.1025 9.7616 28.5552 -11.1584 +5451 6 33.3485 5.72785 21.4502 -30.5322 15.1217 -10.2054 +5452 4 32.7106 6.21453 20.8566 24.3968 -18.0484 15.2917 +5453 4 34.2142 6.02589 21.2258 21.3261 10.3595 -12.9949 +5454 6 25.3097 5.14436 4.52462 -12.6707 -6.42781 10.7366 +5455 4 25.8166 5.03621 5.34324 9.24373 -0.000563512 -7.52253 +5456 4 24.4109 4.89546 4.80865 9.45245 1.955 -8.20101 +5457 6 40.4804 35.6472 19.1595 -4.18239 -17.2552 -25.1441 +5458 4 40.6473 35.1871 19.989 -0.677015 6.66802 10.9293 +5459 4 40.3876 36.5867 19.2889 2.08163 9.85771 9.62751 +5460 6 49.6466 30.6357 19.0258 14.8172 21.4531 -43.5404 +5461 4 50.0494 29.991 18.4245 -6.82309 -11.6442 2.45506 +5462 4 49.4912 30.1943 19.8303 -8.11919 -24.8089 39.0949 +5463 6 42.1414 28.3198 17.0336 30.9261 -8.96587 16.5499 +5464 4 41.9014 28.1134 16.1233 0.612516 -1.09878 -6.61247 +5465 4 42.9986 27.8356 17.2327 -32.0588 11.6021 -17.9905 +5466 6 47.7009 24.529 36.3602 12.6164 -10.6945 -29.4467 +5467 4 46.9511 23.9476 36.4057 -12.614 -6.01445 14.1932 +5468 4 48.02 24.3175 35.4647 6.89481 1.31964 6.68358 +5469 6 19.3487 26.9773 19.8132 -7.91098 29.1703 -3.69101 +5470 4 19.5772 26.0513 19.7652 -2.42994 -17.6971 2.90599 +5471 4 18.7132 27.1892 20.5145 5.94626 -13.5516 -3.80193 +5472 6 47.0594 26.8038 37.5124 29.171 -27.35 55.5912 +5473 4 46.5442 27.3901 37.0243 -28.7601 35.2651 -40.4696 +5474 4 47.4575 26.1126 36.9775 -8.83233 1.8809 -11.4479 +5475 6 9.306 24.6801 40.2841 31.4937 0.109789 0.329283 +5476 4 9.78189 23.9102 39.8717 -14.0424 16.7407 17.3327 +5477 4 10.0272 25.2082 40.7306 -19.6308 -16.1327 -14.1874 +5478 6 14.4855 17.9139 14.2735 23.8217 -2.3356 -5.96097 +5479 4 13.7756 18.1909 13.6871 -0.445295 3.10639 3.20472 +5480 4 15.2926 17.8532 13.6969 -24.9099 1.36359 15.4275 +5481 6 37.1333 38.6708 18.7289 9.24178 15.507 -32.6939 +5482 4 36.7257 39.5382 18.5851 -4.02817 -0.227247 6.07181 +5483 4 37.6697 38.5833 17.9067 -2.91955 -11.3843 16.172 +5484 6 11.4153 5.92336 21.4477 15.4675 -15.5323 24.3843 +5485 4 12.0347 5.46444 22.0611 -14.8481 11.1792 -11.8992 +5486 4 10.9828 5.22117 20.955 -5.02219 -4.37746 -7.57367 +5487 6 4.24672 30.7112 16.2271 25.0754 -37.7862 10.5022 +5488 4 4.05441 31.4608 15.7204 -4.71706 34.9582 -31.1175 +5489 4 3.72964 30.8334 16.9988 -11.892 -2.06994 24.4228 +5490 6 17.6689 16.0105 27.0706 -11.532 -19.4613 -16.5334 +5491 4 17.475 15.0322 27.0999 0.550485 29.0366 -12.0979 +5492 4 17.2014 16.3875 26.2691 10.8221 -16.0252 20.0561 +5493 6 36.4979 8.6445 40.4253 22.1182 5.90925 -1.87084 +5494 4 36.6649 9.56092 40.6574 -3.64727 2.10984 0.486612 +5495 4 35.6642 8.36755 40.7885 -12.5441 -1.64485 2.44437 +5496 6 13.6104 12.9476 3.01337 -0.796658 -1.76047 52.4558 +5497 4 13.281 12.534 3.85665 2.0295 3.09436 -35.1239 +5498 4 14.3672 13.4568 3.35498 1.79634 -1.71495 -16.7359 +5499 6 38.5663 20.1511 21.6276 16.2684 -2.59448 10.3838 +5500 4 39.225 20.3435 20.957 3.66548 0.723189 -1.42015 +5501 4 37.7399 20.1987 21.178 -26.4348 -4.9091 -11.1397 +5502 6 51.0002 10.2707 30.836 -20.0759 -41.5967 21.7358 +5503 4 51.4945 11.0341 30.626 15.2265 30.1997 -10.6067 +5504 4 50.365 10.1656 30.1217 2.42758 1.75416 -9.76943 +5505 6 16.2768 2.44039 41.3342 24.5898 23.894 -47.9169 +5506 4 15.7659 1.68969 41.4668 -26.4768 -52.1654 31.458 +5507 4 16.2309 2.46185 40.3616 9.12406 8.41144 7.6857 +5508 6 16.5823 4.96192 41.8916 -4.82165 52.2801 -70.6027 +5509 4 16.7504 4.9538 0.881833 10.2709 -3.72182 62.3109 +5510 4 16.3825 4.09214 41.6138 -6.48385 -26.7637 5.90228 +5511 6 38.2132 37.6512 20.9834 35.6931 -0.0015793 9.16781 +5512 4 38.1132 38.2158 20.1985 1.71026 -5.63736 5.42755 +5513 4 39.175 37.679 21.2752 -35.8773 5.52261 -11.9395 +5514 6 27.3063 1.90932 15.7743 -36.1781 7.04456 22.02 +5515 4 27.5288 1.21363 15.1745 3.62804 -9.29946 -19.0329 +5516 4 26.3092 1.89423 15.8276 27.8398 0.929522 -3.41863 +5517 6 29.0129 12.4346 37.8081 29.6396 -2.3639 23.3235 +5518 4 29.5703 13.228 37.8521 -9.25731 3.38449 -11.2245 +5519 4 29.432 11.8866 38.5178 -20.735 6.92768 -10.3763 +5520 6 46.0725 20.1624 18.9069 6.39102 14.9163 -14.6323 +5521 4 45.1723 20.516 18.8892 1.91785 -0.379773 0.405435 +5522 4 46.587 20.7656 18.3221 -3.54001 -13.7442 9.74416 +5523 6 2.03634 38.6845 18.4933 3.82981 -3.85695 21.6638 +5524 4 2.81563 38.6864 19.0472 23.4807 10.2435 -12.678 +5525 4 1.45125 38.3557 19.1766 -27.1945 -1.99387 -8.3623 +5526 6 44.0469 24.9707 25.966 7.80173 10.6441 20.9452 +5527 4 44.2747 24.0363 26.0952 1.37736 2.33249 -4.33209 +5528 4 43.5784 25.0701 25.1359 -3.49858 -7.6437 -6.59112 +5529 6 5.98346 26.6137 4.53144 23.0758 4.04073 24.4329 +5530 4 6.55391 27.1627 5.13089 -15.1794 -12.3526 -15.6845 +5531 4 6.29729 25.6938 4.67268 -13.7287 18.2257 -9.78447 +5532 6 0.087877 23.2081 10.934 24.9145 3.46447 1.10559 +5533 4 0.685292 23.7315 10.3726 -8.08066 -2.01306 3.92681 +5534 4 0.721975 22.7627 11.5282 -19.4067 -0.934622 -1.78644 +5535 6 39.1228 20.6282 12.8796 23.5823 -4.01912 3.74068 +5536 4 40.0483 20.9095 13.1274 -25.2182 -11.8294 -4.75086 +5537 4 38.9288 21.0058 12.0111 3.51405 8.21934 1.48951 +5538 6 39.9585 39.9542 18.8548 8.25477 7.63818 -34.14 +5539 4 39.6086 40.5348 18.1328 12.8912 -23.3113 16.3656 +5540 4 39.4227 40.1355 19.596 -22.4924 5.25798 25.9214 +5541 6 49.2764 23.011 30.5163 -3.77364 -44.6036 15.8547 +5542 4 49.4289 23.7872 30.0082 18.6126 30.182 -14.9565 +5543 4 49.9621 22.8706 31.1946 3.66181 18.5012 -4.70792 +5544 6 10.3518 2.34263 9.13761 -0.60969 70.0656 33.4022 +5545 4 10.2194 1.51752 8.76453 -19.3013 -48.5596 -30.1763 +5546 4 9.57958 2.95755 9.02478 16.8019 -18.7251 -1.57756 +5547 6 9.61453 40.9339 19.7468 19.8516 -54.9951 -16.0575 +5548 4 9.63195 40.6865 18.7859 0.317082 16.3896 20.6195 +5549 4 10.0376 40.0904 20.1458 -24.9194 43.0231 -10.2629 +5550 6 29.2525 5.10109 17.4961 7.67774 22.6856 2.90325 +5551 4 29.0408 4.77134 16.6193 -6.82779 -3.03985 -6.7526 +5552 4 29.5295 6.02934 17.3335 -2.58265 -16.5067 4.76001 +5553 6 27.0985 15.4102 3.23556 -13.4453 -81.1273 -7.3603 +5554 4 27.3652 16.2806 3.27349 18.8182 67.1491 11.283 +5555 4 27.7776 14.8512 3.68225 -14.3437 21.6428 -0.863725 +5556 6 32.8444 39.3852 25.121 -7.01244 -52.8845 44.4676 +5557 4 32.5131 40.2222 24.9368 -10.8075 51.8916 -16.2411 +5558 4 32.4445 39.2315 26.0289 16.1191 -0.874654 -30.671 +5559 6 34.9513 7.88207 31.2328 20.4504 58.5219 2.42802 +5560 4 34.2036 8.45679 31.498 3.65199 -12.2289 -1.35309 +5561 4 34.6861 6.99719 31.2488 -20.0023 -44.0519 1.25651 +5562 6 6.12467 36.7605 26.1486 23.5936 30.152 20.8626 +5563 4 6.61267 37.4751 26.6609 -18.7565 -29.2185 -15.3031 +5564 4 6.64666 36.6639 25.3566 0.873799 -8.15108 -9.63468 +5565 6 6.01736 25.8242 24.1032 -23.71 11.4997 43.6127 +5566 4 6.27054 25.4519 24.9889 5.69321 0.899098 -34.3464 +5567 4 5.25039 26.3671 24.4036 11.002 -12.3451 -22.9516 +5568 6 45.616 24.3868 2.54557 6.93899 11.9467 -1.18645 +5569 4 46.5025 24.2318 2.18535 0.269069 -11.0786 2.08994 +5570 4 45.6283 24.2142 3.48441 5.93067 -6.10702 12.3332 +5571 6 15.5106 11.7053 32.6869 22.7313 15.5035 25.4621 +5572 4 15.7644 12.551 33.1413 -9.31293 -24.2108 -12.4541 +5573 4 14.956 11.9719 31.9681 -12.2379 8.7831 -14.7046 +5574 6 46.4141 17.7037 37.4783 -24.8433 -42.9552 -46.1347 +5575 4 46.5841 17.8832 38.3706 6.4658 9.03355 44.3658 +5576 4 46.0203 16.778 37.4148 6.08678 36.5836 2.96135 +5577 6 39.713 20.917 18.528 13.2313 30.5311 40.8197 +5578 4 40.433 20.5782 18.0298 13.2747 -18.0123 -24.5712 +5579 4 40.2054 21.5165 19.1543 -30.2447 -12.7963 -15.6911 +5580 6 23.8051 28.0334 36.6648 -18.7533 17.1228 48.8478 +5581 4 23.301 27.37 37.1661 8.15196 -5.41595 -20.5023 +5582 4 23.699 28.7533 37.3439 14.557 -4.10395 -29.4534 +5583 6 23.235 0.659798 30.8906 16.7198 -34.3804 0.301059 +5584 4 23.3562 41.8891 31.5781 -2.93034 5.1259 -1.85649 +5585 4 23.9222 0.433479 30.2226 -16.4688 10.6885 3.12481 +5586 6 37.1438 6.89027 28.2945 -2.75708 2.50278 32.0481 +5587 4 36.7625 6.23385 28.9496 14.7229 22.3106 -21.8828 +5588 4 37.4874 7.65333 28.8474 -13.0775 -21.14 -18.6628 +5589 6 3.23769 6.61111 12.3846 0.723209 -17.9385 -9.61551 +5590 4 2.93962 6.7917 11.4726 6.04883 11.0603 10.3219 +5591 4 3.59705 5.70622 12.3141 -7.8292 10.6871 9.81534 +5592 6 12.6213 19.1513 31.1215 -11.7593 -39.2703 -9.13055 +5593 4 12.5689 18.1911 31.4279 4.41954 36.1073 -0.401864 +5594 4 12.3049 19.0952 30.1995 4.23471 8.33584 13.9505 +5595 6 15.1895 38.3194 41.5508 -8.26313 0.106571 5.96729 +5596 4 15.4027 38.685 40.6867 1.58925 3.7734 1.08261 +5597 4 15.977 37.8419 41.8199 8.82113 -1.67422 -0.112624 +5598 6 49.6344 33.3417 19.6414 -43.1776 -42.2962 -0.847743 +5599 4 48.6794 33.3996 19.9697 35.2792 3.84356 -17.7841 +5600 4 49.66 32.3974 19.2778 11.8172 40.1309 17.1575 +5601 6 6.36572 2.78375 29.9004 1.05055 15.8156 -22.8281 +5602 4 6.36575 3.75042 29.7262 1.90425 -15.9719 7.25575 +5603 4 5.96593 2.68858 30.7619 0.24665 -4.47807 16.8647 +5604 6 13.1696 31.768 30.2754 -6.44409 10.1839 -14.6274 +5605 4 12.7931 32.0108 29.386 8.00869 -8.49993 19.6421 +5606 4 12.9985 30.8211 30.4317 -1.17466 7.15103 -3.10169 +5607 6 32.315 32.2433 24.9103 28.3535 -13.0924 -48.465 +5608 4 32.6582 31.5201 24.3183 -18.8106 4.4732 28.5514 +5609 4 32.6906 33.004 24.4312 -3.21058 9.63112 20.1287 +5610 6 42.0003 14.5628 37.421 -39.889 12.6212 -8.37855 +5611 4 41.095 14.1415 37.3281 37.9102 -1.96214 -0.320241 +5612 4 42.7025 13.9066 37.3517 -4.02931 -15.6388 2.60245 +5613 6 11.8892 7.23447 27.6701 3.45884 -4.12236 4.5236 +5614 4 11.8415 6.40302 28.2109 -4.80024 17.2153 -14.4092 +5615 4 11.297 7.16355 26.8983 -0.411327 -9.99206 8.34553 +5616 6 14.2054 37.5349 6.88535 -5.50304 -50.1586 -23.8091 +5617 4 14.4448 38.4425 6.82842 11.1201 34.2121 -5.16838 +5618 4 14.5404 37.0855 6.04727 -8.45912 19.5264 31.302 +5619 6 14.2389 30.7101 36.0658 7.9951 22.3707 -6.00421 +5620 4 14.3369 30.7582 35.119 5.20948 5.89711 -15.5268 +5621 4 14.162 29.7856 36.1796 -2.50712 -40.828 17.27 +5622 6 16.4199 33.6465 5.49971 39.8982 -12.4718 -37.0106 +5623 4 16.8881 34.472 5.38053 -10.1033 13.7438 12.8324 +5624 4 16.9383 33.116 4.82328 -31.4907 -2.1142 22.2677 +5625 6 23.0347 17.1509 7.84843 -2.98061 53.305 10.417 +5626 4 22.2528 17.4913 7.37616 0.35347 -20.1342 1.7373 +5627 4 23.3535 18.0122 8.2624 2.91922 -40.8936 -9.01863 +5628 6 51.739 20.8998 27.7117 45.1346 -9.91933 19.8422 +5629 4 51.4539 20.5938 28.5983 0.576611 5.87017 -14.8878 +5630 4 52.7517 20.9693 27.7878 -43.3794 -0.870523 -11.1135 +5631 6 2.19386 27.6013 28.8077 21.9852 1.77593 -20.6905 +5632 4 2.90112 28.2633 28.7865 -8.94698 7.25322 21.5481 +5633 4 2.57794 26.9939 28.1568 -21.2327 -10.3447 8.82052 +5634 6 17.2209 14.3445 7.70498 -9.6153 -40.0176 25.3709 +5635 4 16.7414 14.2178 8.5755 19.2823 5.01031 -25.0594 +5636 4 17.7242 13.4894 7.54274 -12.7499 32.9606 1.11211 +5637 6 12.4553 8.94194 14.7093 23.4905 -30.5738 22.1451 +5638 4 12.3295 7.96561 14.6517 -10.6336 18.1935 -14.5798 +5639 4 13.0902 8.95069 15.466 -13.8235 22.031 -14.7981 +5640 6 42.4163 38.0607 9.75492 -41.3892 12.3524 0.930734 +5641 4 43.2155 37.8504 10.1985 23.5031 -2.65638 19.8551 +5642 4 41.8128 38.5249 10.3845 19.1619 -5.0707 -9.72644 +5643 6 51.8291 30.3524 28.2725 -23.4976 -15.3182 24.0858 +5644 4 51.4769 31.1806 28.0071 -16.9091 20.9854 -6.54852 +5645 4 52.5669 30.2698 27.7075 37.0459 -10.0857 -13.876 +5646 6 0.173291 18.5306 4.58887 -6.78508 26.3933 6.63194 +5647 4 0.366643 18.0957 3.77581 2.61413 -8.62723 -27.1515 +5648 4 0.528197 17.9664 5.25604 0.668563 -20.2899 17.5992 +5649 6 34.1542 0.618182 3.01035 -64.6642 7.59467 -29.5426 +5650 4 33.2756 0.91071 2.55681 38.9521 -14.8268 28.0312 +5651 4 34.8139 1.0189 2.46529 20.392 14.9436 -5.19898 +5652 6 49.1703 17.2445 23.163 11.3421 -28.7232 -23.3687 +5653 4 50.0948 17.5226 22.997 -11.4987 -1.8789 7.34388 +5654 4 49.1149 16.3391 22.7575 3.35316 27.0342 8.27414 +5655 6 23.1508 6.50484 23.6205 15.3745 23.1125 -33.0506 +5656 4 23.1854 7.14565 22.8174 -14.1016 -25.0292 28.8988 +5657 4 22.2566 6.27815 23.8868 -11.3625 11.3028 -1.57795 +5658 6 11.0777 24.0866 29.2726 3.42799 -14.5151 -26.2344 +5659 4 11.3051 23.4915 28.5104 -10.7193 12.1306 15.2701 +5660 4 11.7189 23.8646 29.9475 6.00027 1.59973 10.1126 +5661 6 36.5499 4.08922 21.6769 -9.80126 5.87302 -21.3361 +5662 4 36.3976 4.50823 22.521 3.21878 -0.144303 13.033 +5663 4 36.3054 4.80832 21.0596 6.63301 -13.9203 1.83546 +5664 6 31.3023 25.6432 24.5943 15.0376 6.85795 28.0728 +5665 4 31.291 26.2789 25.3519 -12.6017 -14.5788 -25.478 +5666 4 32.0941 25.1064 24.7955 -9.59576 -0.449362 -7.93794 +5667 6 42.6065 23.029 14.7662 -46.2562 -12.0705 -53.1337 +5668 4 42.8654 23.3474 13.8766 8.33796 6.77145 13.2285 +5669 4 43.1929 23.285 15.4255 44.8404 21.8098 38.991 +5670 6 14.3111 11.6689 8.88632 -19.0153 -23.9468 -21.906 +5671 4 13.3495 11.3817 8.87766 31.9146 14.5471 0.24728 +5672 4 14.742 11.0378 8.25313 -7.14597 12.5116 20.7778 +5673 6 21.4992 2.13393 3.40246 8.36864 -2.88126 -9.61958 +5674 4 22.4231 2.22963 3.69686 -12.58 -3.45743 -2.69439 +5675 4 21.4721 1.34946 2.81138 2.62282 6.56171 18.4043 +5676 6 22.4667 27.6841 39.0793 -16.1771 -11.2193 -33.3168 +5677 4 22.9487 28.2311 39.6723 13.8114 13.1168 21.0188 +5678 4 22.2331 26.8853 39.529 -0.753476 -8.75647 11.2468 +5679 6 37.2752 33.5075 30.0534 -5.09816 -29.8969 21.2662 +5680 4 36.5321 32.9121 30.2938 11.1992 13.6878 -5.37502 +5681 4 38.0391 33.1092 30.5204 -9.59535 7.6329 -11.7718 +5682 6 41.8356 20.8755 40.0084 -30.1785 -26.2846 -15.3963 +5683 4 40.891 20.6843 40.2338 21.7839 7.55089 -6.55796 +5684 4 42.213 21.2736 40.7728 12.4306 8.07023 23.0746 +5685 6 10.0585 31.1051 22.2503 24.8691 -18.1602 32.094 +5686 4 10.0242 30.9652 23.2199 -0.323131 -4.21186 -18.2592 +5687 4 9.26251 31.5457 22.0526 -32.5358 14.9165 -12.561 +5688 6 24.2061 35.3797 6.65176 29.8647 -7.74501 -52.0461 +5689 4 23.2981 35.13 6.46942 -12.5131 3.59528 11.7489 +5690 4 24.436 35.6291 7.5325 -13.5066 3.92126 26.0938 +5691 6 54.2205 13.3707 18.7548 -14.8606 0.23157 2.49876 +5692 4 53.5905 13.2954 18.0026 12.0308 5.79113 16.3195 +5693 4 53.7072 13.5032 19.578 4.97112 -2.65932 -16.1217 +5694 6 12.4895 25.0856 17.4479 -5.54126 21.12 19.6166 +5695 4 12.0527 25.8035 17.9613 1.96295 -15.4272 -10.9144 +5696 4 12.9797 24.5872 18.1192 -7.22993 -2.38631 -13.5888 +5697 6 22.3914 33.9622 18.8899 -17.7941 -3.8788 -25.186 +5698 4 22.7777 34.3519 18.0802 1.20341 3.55679 12.7761 +5699 4 21.5828 33.5138 18.532 26.0363 5.82114 13.25 +5700 6 24.4442 12.917 5.83205 -1.35281 -9.13891 6.68087 +5701 4 24.5112 13.8355 6.04562 11.139 23.8521 5.95609 +5702 4 23.7978 12.9208 5.12829 -4.38592 -8.75699 -5.70796 +5703 6 13.4045 11.2384 28.602 -9.94106 -32.5269 -0.345522 +5704 4 13.7125 10.4202 28.1467 1.06973 22.7078 1.68844 +5705 4 12.6883 10.856 29.1417 2.50959 12.0169 -5.49025 +5706 6 20.9681 34.6931 21.1354 15.1203 14.42 -6.16036 +5707 4 21.5009 35.1121 21.8248 -8.94458 -7.77672 4.1779 +5708 4 21.5063 34.8208 20.3262 -11.2236 -10.4562 8.09593 +5709 6 37.1336 34.5207 26.1541 -9.5297 -36.7224 -3.07541 +5710 4 37.2109 34.2142 25.2288 3.21082 15.1766 11.7274 +5711 4 37.5352 35.3664 26.2639 8.9577 18.3348 -6.65469 +5712 6 49.3622 27.1182 23.4746 39.7066 -11.0301 13.9767 +5713 4 48.4746 27.3502 23.3119 -43.65 9.96054 -8.06751 +5714 4 49.6716 26.7458 22.6451 -3.30563 -9.15784 -7.68388 +5715 6 2.6564 41.733 27.6477 -1.65257 -10.3676 0.180548 +5716 4 2.5349 41.5868 26.6785 2.71482 14.5166 10.808 +5717 4 3.44733 0.360291 27.8573 -13.8821 -2.9337 -13.5775 +5718 6 28.2538 5.65865 0.855763 -50.2522 -11.1502 7.99105 +5719 4 29.1126 5.92525 0.635025 43.8938 8.11388 -11.2713 +5720 4 28.2366 4.68907 0.832778 5.05155 4.08711 2.73992 +5721 6 46.3376 19.9476 30.6448 -5.32264 7.02196 22.3264 +5722 4 46.9473 19.8004 29.9179 3.84913 9.17517 -5.42643 +5723 4 46.6125 20.7672 31.1318 -5.12963 -19.3092 -16.4827 +5724 6 3.64577 25.7701 21.5553 -12.766 27.4814 -12.397 +5725 4 3.72382 24.8593 21.8343 3.84868 -9.88757 -5.52558 +5726 4 3.13913 25.8588 20.7173 13.2009 -15.3518 9.10855 +5727 6 2.75122 19.0968 29.6319 -2.61118 -0.882922 8.96218 +5728 4 3.5891 18.6871 29.8565 3.14038 -9.81989 10.1431 +5729 4 2.90737 19.4327 28.7602 3.1882 14.1904 -12.7773 +5730 6 11.8953 35.7778 24.2646 -23.8517 23.4638 0.926703 +5731 4 12.2722 34.9198 24.2954 23.5909 -23.1933 0.784725 +5732 4 12.5229 36.3761 23.8548 12.2449 3.68762 -3.83655 +5733 6 52.3409 30.3775 14.3038 25.9342 24.3497 3.27132 +5734 4 52.8186 31.1218 14.7277 1.28259 -10.3571 -1.87569 +5735 4 51.5459 30.7912 14.0165 -25.7225 7.74731 -5.34623 +5736 6 0.083662 24.3704 32.1159 7.87696 -1.86575 0.949534 +5737 4 0.925887 24.7254 31.8116 -7.58302 1.2158 -10.0766 +5738 4 0.064605 24.6797 33.0182 -11.6947 5.89195 12.8097 +5739 6 31.4941 23.7355 38.8139 13.6067 4.55671 22.3988 +5740 4 31.5922 23.3599 39.6955 6.6148 17.5079 8.63317 +5741 4 30.9989 23.0266 38.4646 -21.4094 -18.5611 -29.2329 +5742 6 52.1193 21.6104 3.49599 14.6151 -31.0847 -13.388 +5743 4 52.9641 21.5934 2.99085 -20.8635 4.42776 5.19501 +5744 4 52.1025 22.4297 3.95509 1.85636 27.8943 8.87727 +5745 6 31.7523 33.9412 11.6017 9.59211 -24.6365 -8.99112 +5746 4 31.343 34.2459 12.4067 -7.95657 10.1636 10.9534 +5747 4 32.0734 33.0348 11.7994 -4.73133 20.193 -2.42319 +5748 6 7.03486 17.6719 16.6685 29.0057 -41.5114 -49.367 +5749 4 6.91092 17.0215 17.3537 -7.78637 4.64801 28.8113 +5750 4 7.29826 17.0034 15.9319 -18.9591 50.1453 28.7374 +5751 6 51.8542 41.8728 22.1898 10.246 17.2442 -13.5357 +5752 4 52.3028 41.4443 22.9054 19.3182 -6.61148 18.5368 +5753 4 51.1068 41.3135 22.0792 -27.0964 -11.4612 -2.03348 +5754 6 50.8737 9.93347 25.9376 -32.929 -21.31 0.307119 +5755 4 50.6075 10.0984 25.0351 -2.54905 2.45869 -5.94774 +5756 4 51.7134 10.3221 26.0527 29.2363 20.0336 5.9403 +5757 6 9.00178 39.8723 13.8451 -19.3622 -18.1235 -30.983 +5758 4 9.55792 39.3182 14.3856 9.60602 -5.37935 8.26515 +5759 4 8.70771 39.29 13.0873 14.4347 20.6992 23.854 +5760 6 40.6986 25.5526 0.136544 19.9096 -17.3535 33.0343 +5761 4 40.3666 25.3638 1.04053 0.834228 7.76146 -13.9079 +5762 4 41.6521 25.7245 0.296606 -16.7956 -8.725 -14.7957 +5763 6 46.6823 7.83196 22.8561 10.1499 25.8504 33.9562 +5764 4 46.2788 7.49308 23.6743 -2.78909 -8.0392 -13.1915 +5765 4 47.099 8.65892 23.1926 -4.50937 -8.82075 -14.1875 +5766 6 20.9875 12.9068 9.95805 -11.691 32.2034 24.7109 +5767 4 21.4351 12.3054 10.5167 21.854 -26.8991 22.1196 +5768 4 21.3309 12.7465 9.11062 12.4417 -9.66517 -44.3579 +5769 6 24.8453 0.514421 28.6038 13.082 22.7197 -2.81433 +5770 4 24.715 0.071792 27.7548 -6.16819 -1.63374 -2.91335 +5771 4 25.0442 1.45997 28.4028 -6.72102 -19.281 3.08734 +5772 6 9.94041 22.6855 8.28517 -18.2906 18.759 -35.6321 +5773 4 10.3442 21.9586 7.83344 17.071 -18.1108 1.7387 +5774 4 9.60436 23.1702 7.48056 7.13277 7.40532 33.7222 +5775 6 33.2759 9.25429 23.8257 8.37106 -55.2845 13.9355 +5776 4 33.3237 10.1123 23.4806 -1.26345 47.1757 -20.4798 +5777 4 34.1087 8.81977 23.5578 -8.47821 6.16632 5.2483 +5778 6 47.7984 20.3614 34.2959 -41.6158 20.0741 -32.6301 +5779 4 47.162 20.9095 33.7523 35.4977 -6.5354 18.8426 +5780 4 47.2264 19.5923 34.4121 13.8381 -6.37745 11.1074 +5781 6 7.49292 13.4971 41.09 9.79805 -11.8131 -23.6679 +5782 4 7.49901 13.1324 40.1715 -6.0705 12.8605 17.5951 +5783 4 8.32745 13.1637 41.4633 -5.36906 3.36653 2.36319 +5784 6 9.96112 23.6102 1.61114 1.89646 0.256416 -8.05524 +5785 4 10.3422 24.1467 0.893187 3.70522 0.0162214 12.766 +5786 4 9.63217 22.8308 1.16111 -2.5861 -8.4474 -3.4617 +5787 6 27.3279 14.1675 11.3384 -16.3978 3.93745 18.7515 +5788 4 27.0565 14.7974 10.6584 -0.154384 0.736593 1.51299 +5789 4 26.9739 14.5213 12.1957 15.9081 -3.44829 -24.7787 +5790 6 25.8416 31.7729 17.8867 -18.6075 -57.137 -13.4601 +5791 4 26.5498 31.1652 17.5816 -7.88637 19.42 8.67928 +5792 4 26.1364 32.6121 18.1157 31.0786 47.9057 11.8145 +5793 6 28.5054 34.3394 0.220618 54.67 33.5077 11.5224 +5794 4 29.0324 33.8757 0.885908 -4.94848 -3.20805 0.921423 +5795 4 27.711 33.8992 0.092994 -46.8158 -31.9819 -6.78258 +5796 6 39.4821 27.6754 22.7241 37.6977 26.8974 -34.7457 +5797 4 38.562 27.8477 22.7631 -35.1425 8.51836 6.28403 +5798 4 39.8483 28.4606 22.2037 -4.4779 -30.5719 17.4824 +5799 6 19.3989 35.5068 37.6449 44.7238 7.00696 26.241 +5800 4 18.7939 34.9286 37.217 -17.2642 -20.3375 -13.2178 +5801 4 20.0787 34.9056 38.0699 -27.4009 15.1777 -18.4057 +5802 6 40.2622 30.2205 10.7395 23.7464 -4.20556 -44.2191 +5803 4 39.872 30.2327 11.5724 -12.5687 -7.32393 56.9787 +5804 4 39.6265 30.6987 10.2193 -5.46151 14.1383 -16.826 +5805 6 44.8252 28.4803 36.0885 -55.5401 -40.4399 48.4955 +5806 4 44.0914 27.9458 36.6324 49.8455 26.3412 -39.6007 +5807 4 44.7386 29.3482 36.4954 11.2485 4.05282 -13.3799 +5808 6 17.9305 13.9374 34.278 5.37655 43.1893 -39.9004 +5809 4 17.3503 14.7126 34.0365 12.4853 -29.216 13.3111 +5810 4 17.5732 13.4499 34.9957 -23.6035 -11.4222 25.4792 +5811 6 22.772 11.7897 25.9182 -5.92321 66.9234 -24.4623 +5812 4 22.4079 10.9608 26.1065 -2.80798 -46.2844 14.8143 +5813 4 23.7282 11.8442 25.9391 13.2658 -20.917 3.34216 +5814 6 27.9678 31.9745 40.3581 9.67064 -3.036 11.5355 +5815 4 28.3415 32.7469 39.952 3.83939 12.9153 -6.44865 +5816 4 27.8423 31.3481 39.6454 -9.64166 -7.41544 0.62615 +5817 6 29.7189 5.14175 29.7003 46.1252 -36.6163 -19.9261 +5818 4 29.2969 5.47215 30.4671 -15.8461 16.6952 32.1509 +5819 4 30.5834 4.69597 30.0017 -39.473 23.5261 -13.8417 +5820 6 3.10812 21.482 2.76797 0.178067 -30.2305 -7.76436 +5821 4 2.88389 22.394 2.68207 -8.68283 21.8462 0.431797 +5822 4 2.52465 20.9987 2.15107 4.11904 7.00085 10.9335 +5823 6 13.6455 30.6616 39.7413 -31.0251 6.24286 -53.6991 +5824 4 14.4958 30.9276 39.9901 40.59 7.52955 18.7737 +5825 4 13.6028 30.9637 38.7781 -13.7388 -14.6365 40.9566 +5826 6 39.1879 23.0833 28.2631 23.8153 34.0131 -40.8644 +5827 4 39.3603 23.1915 27.276 -9.32936 -4.03115 31.7012 +5828 4 38.6771 22.3028 28.3825 -19.3689 -24.2853 3.44718 +5829 6 16.9942 23.7475 0.782551 23.2332 -11.0525 -6.02825 +5830 4 16.1835 23.4907 1.22514 -0.204047 -3.07314 3.44284 +5831 4 17.6924 23.1245 1.11262 -18.9135 18.2649 -2.71213 +5832 6 0.34625 33.6655 13.0265 -29.0282 32.855 38.2597 +5833 4 54.9333 33.1158 13.7076 7.16186 -20.0974 -8.4449 +5834 4 0.196186 34.5312 13.5136 21.864 -23.0202 -35.8666 +5835 6 49.1134 40.6592 16.9502 -22.6074 7.13526 -12.7963 +5836 4 49.0929 41.0585 16.0481 9.95068 -10.3513 11.1088 +5837 4 48.1763 40.6949 17.2078 7.5264 3.31219 -3.37923 +5838 6 52.1371 39.9932 15.179 23.5783 8.13152 6.60826 +5839 4 51.9212 40.0798 16.1068 2.92809 -1.65288 7.91558 +5840 4 51.3496 39.6649 14.7978 -27.1925 -6.99882 -20.2103 +5841 6 29.0492 37.0934 37.8397 27.862 0.580994 -15.5106 +5842 4 29.7824 36.6456 38.29 -13.83 -0.942856 -3.03347 +5843 4 28.3401 37.1923 38.4583 -14.8343 8.34268 17.6028 +5844 6 4.87483 1.47389 27.5722 8.99005 1.78018 0.412076 +5845 4 5.18955 1.04652 26.7639 -2.94161 4.65408 6.15856 +5846 4 5.65876 1.67721 28.1054 -5.69693 -0.488114 1.02013 +5847 6 43.5905 24.3648 30.2005 -22.2044 -15.6763 19.9702 +5848 4 44.3573 23.9419 29.8442 19.8319 -9.6252 -11.3654 +5849 4 42.9995 23.6287 30.4468 4.54232 11.3491 -5.57307 +5850 6 33.7546 3.53169 22.9281 6.20171 -10.3572 -20.5792 +5851 4 34.1788 2.72522 22.5548 -7.61164 22.2296 6.95503 +5852 4 33.66 4.19918 22.2026 -0.715781 -19.232 19.3758 +5853 6 19.8847 13.4579 25.4063 -13.0952 -9.58357 -31.6265 +5854 4 20.5464 14.0819 25.6574 14.0517 10.8301 14.4774 +5855 4 19.8633 12.7253 26.0209 8.35596 -5.88238 10.9252 +5856 6 47.3765 23.175 39.6238 -8.62258 12.6683 8.16714 +5857 4 47.7656 22.5263 39.0394 4.03481 -11.1372 -12.2265 +5858 4 47.7314 24.026 39.3382 2.38196 -1.35255 2.76448 +5859 6 20.1792 18.6695 32.3892 10.8118 -11.8558 9.82813 +5860 4 19.7451 19.3837 31.9609 -18.6549 15.8768 -14.4176 +5861 4 21.1063 18.8885 32.2904 5.57481 -8.22146 4.6255 +5862 6 0.469489 5.80056 25.6694 -18.1951 25.8664 -34.3154 +5863 4 0.192512 6.63022 25.2132 12.4788 -26.9708 -4.90825 +5864 4 0.599388 6.15564 26.5295 8.98284 3.20038 34.2611 +5865 6 6.87796 19.5502 31.9212 -30.9469 28.3562 -15.4034 +5866 4 6.36899 19.9719 32.666 7.94508 -11.3044 -26.1662 +5867 4 6.51823 19.9652 31.058 21.1032 -17.2362 32.6466 +5868 6 6.72006 20.2763 38.5282 -5.5716 11.964 -18.9783 +5869 4 5.89143 20.7831 38.5761 11.8801 -4.42879 -4.55199 +5870 4 6.91977 20.0675 39.4366 -2.33705 -6.77268 4.9945 +5871 6 22.0131 25.9408 12.2669 -3.54377 -45.9259 -44.7125 +5872 4 21.4169 25.4251 11.6232 6.06411 36.0021 36.1209 +5873 4 22.8575 25.5519 12.0003 5.79029 4.70211 8.19546 +5874 6 39.2956 7.94468 2.64777 3.93347 -3.54621 1.69719 +5875 4 39.6192 7.96721 3.55942 2.89932 9.4301 1.57912 +5876 4 39.5223 7.0665 2.33247 5.57505 -8.53159 -3.65477 +5877 6 29.9733 22.0379 34.4029 6.80249 8.99144 -26.5663 +5878 4 30.9486 21.9114 34.4332 -22.6925 2.47334 -4.63229 +5879 4 29.7282 22.2324 33.4511 1.23467 -5.29722 31.1857 +5880 6 37.585 16.2896 0.378862 9.66072 -32.1652 -13.4334 +5881 4 37.1738 15.3958 0.469359 7.4986 19.6703 2.82788 +5882 4 38.3979 16.0784 41.7811 -5.81955 5.34443 7.8674 +5883 6 11.7199 13.8969 21.9024 0.976022 -4.28814 -52.9061 +5884 4 11.762 13.5091 20.9636 8.25344 3.74313 41.2159 +5885 4 11.7301 13.2111 22.5694 -0.197866 -18.3587 0.721586 +5886 6 33.3547 10.9227 27.6206 7.79028 2.98821 -12.2755 +5887 4 32.7398 11.5851 27.2614 8.9286 -8.03905 3.2582 +5888 4 34.0693 10.7866 26.9485 -19.1033 10.7299 13.3482 +5889 6 30.9479 36.5351 10.0985 1.61282 -58.9885 -21.8283 +5890 4 31.0506 36.3975 9.1055 -4.33965 11.8991 35.1417 +5891 4 31.0192 35.5887 10.4601 -6.41155 39.3119 -7.26857 +5892 6 45.5784 6.55949 25.24 49.1938 -13.828 -6.30557 +5893 4 44.6777 6.5515 25.5065 -25.461 -8.09624 7.65514 +5894 4 45.978 5.64009 25.2752 -26.9592 28.1751 -0.0529727 +5895 6 9.53089 30.0259 12.0468 18.203 -29.4993 -35.3826 +5896 4 9.87965 30.5113 11.2809 1.8895 2.86193 6.03312 +5897 4 9.26134 30.6784 12.652 -18.7794 25.6859 27.1844 +5898 6 53.0787 24.9761 1.37462 5.70131 11.5656 52.3682 +5899 4 52.7701 24.171 1.02302 -14.9871 -27.078 -25.8882 +5900 4 53.2426 25.5756 0.676612 4.18045 17.0305 -26.7636 +5901 6 26.1794 24.7359 0.502901 22.1176 -25.6344 -30.1555 +5902 4 25.7034 24.7594 41.5454 1.42755 5.35042 26.0986 +5903 4 25.8798 25.3805 1.12222 -18.0425 21.9232 11.274 +5904 6 23.006 2.41877 11.549 3.03835 0.786733 -23.201 +5905 4 22.1232 2.19651 11.8728 1.75899 -1.65202 1.96434 +5906 4 22.9163 2.42328 10.5701 -3.31062 2.24291 13.1011 +5907 6 29.9286 12.8953 30.9894 2.56623 -0.427284 6.89615 +5908 4 30.7531 12.7948 31.5295 -11.6926 9.48208 -25.7239 +5909 4 30.1452 13.1242 30.0532 3.97045 -7.90132 21.6369 +5910 6 24.0654 16.1863 40.3478 -8.57837 -16.1993 -7.0618 +5911 4 23.8181 16.8167 40.9886 -17.7345 17.1107 43.7161 +5912 4 24.4461 16.799 39.7307 8.03288 -6.21636 -19.956 +5913 6 21.8775 29.9129 12.7438 8.38993 20.3936 0.69825 +5914 4 21.1101 29.6022 12.2761 -16.411 -9.00989 -4.05561 +5915 4 21.7959 30.8814 12.6689 6.66677 -10.3308 5.74649 +5916 6 45.2196 12.276 6.62528 -23.2047 44.1078 30.1736 +5917 4 45.4494 11.529 6.11864 16.0879 -27.9404 -20.133 +5918 4 45.9267 12.944 6.63915 -2.18395 -9.27911 -10.7446 +5919 6 7.59043 25.3914 38.0243 42.7544 -18.087 21.3587 +5920 4 8.2454 25.1294 37.3073 -28.6085 13.3538 22.5553 +5921 4 8.06078 25.1795 38.9036 -17.5445 13.8955 -36.9473 +5922 6 46.1702 7.81994 16.6869 -21.8749 40.0263 -11.2018 +5923 4 46.5308 7.86296 15.7811 2.96678 -6.7279 9.6444 +5924 4 46.6568 7.20863 17.2067 24.29 -27.7199 6.2944 +5925 6 54.9712 12.8519 7.72645 -5.0392 -7.84126 -11.592 +5926 4 54.9715 13.8156 7.65436 -3.45199 -1.13943 9.08655 +5927 4 54.3111 12.5688 8.37934 8.51313 12.0297 -0.864167 +5928 6 26.936 39.6495 37.1759 1.87165 14.912 18.6021 +5929 4 27.6928 39.6002 36.5592 -3.34619 -10.0228 14.3716 +5930 4 27.1866 39.3914 38.108 -0.832196 -0.678219 -33.4669 +5931 6 27.0349 8.92218 38.0169 24.6524 -2.61622 -28.7715 +5932 4 26.316 9.52058 38.1337 -23.9094 17.4181 8.51603 +5933 4 27.4852 9.31616 37.2255 -4.7843 -14.0734 18.554 +5934 6 8.05135 7.65161 29.9116 12.1299 -7.94147 21.2544 +5935 4 8.62851 7.92802 30.6495 -6.35395 -5.29094 -12.0163 +5936 4 7.74814 8.47335 29.5547 -5.2558 18.4649 -14.2469 +5937 6 27.8737 27.8565 12.1051 -38.6038 15.3188 22.9885 +5938 4 27.4445 28.7122 12.3849 14.7215 -19.9621 -4.23437 +5939 4 28.6312 28.0341 11.5799 28.6137 10.9177 -18.1106 +5940 6 23.5548 30.5037 38.1558 -29.4871 -31.9475 26.5081 +5941 4 24.0962 30.758 38.9126 3.93335 7.76671 -5.43794 +5942 4 23.9417 30.8351 37.3772 21.2145 16.4773 -23.4003 +5943 6 48.0793 24.306 17.3344 -19.3615 12.8085 -14.3801 +5944 4 47.2872 24.7421 17.7455 27.359 -7.68532 -3.4425 +5945 4 48.1537 24.7387 16.4546 -0.580236 -6.90317 13.1114 +5946 6 38.498 5.30294 40.3305 40.7021 23.5094 2.62433 +5947 4 38.9475 4.64687 39.7972 -10.9193 -18.4764 2.07144 +5948 4 39.1882 6.01706 40.3225 -28.8653 -3.92995 8.38836 +5949 6 31.2337 3.92695 33.7301 -2.6422 16.6026 -6.87478 +5950 4 31.7948 4.28658 33.0166 -2.97898 -8.44373 7.32517 +5951 4 31.5298 3.03423 33.9266 10.3473 -9.06319 -0.444766 +5952 6 41.2426 8.81864 38.1104 -4.47266 -7.82466 24.3448 +5953 4 41.0373 8.41451 38.9755 -2.01902 1.52645 -10.1427 +5954 4 41.1368 9.75783 38.3095 7.23604 3.04516 -5.74389 +5955 6 53.3619 29.0937 24.5785 -40.2757 11.297 7.14485 +5956 4 52.5565 28.5537 24.7901 26.871 10.2044 -0.818821 +5957 4 52.9453 29.9599 24.3491 20.4755 -15.9472 -3.03 +5958 6 54.9044 15.544 40.7081 25.545 -57.3548 17.1629 +5959 4 54.9892 16.405 40.3633 -12.4948 43.2864 -12.4113 +5960 4 54.018 15.2891 40.9908 -7.57666 14.2468 -5.0348 +5961 6 46.3994 17.0672 31.8767 -6.245 16.1286 -17.5712 +5962 4 46.5114 17.9797 31.5283 3.34232 -11.2714 9.55259 +5963 4 45.8128 16.6602 31.1996 2.74349 5.02824 21.6551 +5964 6 36.898 25.0477 23.0493 11.3229 21.4084 -39.4528 +5965 4 37.2029 24.9737 23.9235 7.13326 -1.42781 43.2733 +5966 4 36.3025 24.3424 22.8486 -15.8402 -9.5757 6.36085 +5967 6 11.3692 4.41343 15.9249 15.7896 22.4119 -17.7964 +5968 4 11.3725 3.62473 15.3598 -3.28732 1.6252 14.2587 +5969 4 11.7055 5.11941 15.3214 -6.01385 -9.48847 12.8461 +5970 6 12.7845 7.07125 19.464 -10.6801 6.56169 22.7508 +5971 4 12.8604 6.27981 18.9655 14.1597 -21.8558 -24.6024 +5972 4 12.2771 6.71627 20.2197 6.8185 19.6013 -8.61559 +5973 6 12.0681 33.6471 17.5522 -1.52085 -17.496 -42.1785 +5974 4 11.9445 34.1189 18.3508 -6.25092 12.897 34.2466 +5975 4 12.5251 32.8183 17.7704 2.9394 6.95993 4.68875 +5976 6 10.2419 4.74292 2.55933 22.7613 10.361 1.71337 +5977 4 9.42389 4.50476 2.9876 -9.73314 -9.75152 7.74431 +5978 4 10.9687 4.12007 2.82053 -14.8261 2.90481 -11.2179 +5979 6 4.58785 36.8771 12.1606 -7.79451 -50.5455 -28.0593 +5980 4 4.4315 37.6675 12.6216 -0.588552 45.9766 17.7929 +5981 4 5.40236 36.9214 11.6472 0.781205 5.58305 7.99313 +5982 6 30.7591 35.3322 25.8391 -38.6972 -6.70904 -25.8809 +5983 4 31.308 35.3014 26.6139 2.09136 -3.6723 11.5509 +5984 4 29.8922 34.8696 26.0006 25.0535 4.09477 3.57125 +5985 6 20.1826 7.15897 1.87495 42.3449 13.1453 -15.8992 +5986 4 20.9155 6.54161 2.14653 -26.0098 16.5163 -6.36728 +5987 4 20.7109 7.92751 1.4772 -24.8109 -25.5601 12.7141 +5988 6 21.7554 6.89613 28.9929 -8.55274 -2.37394 -9.1913 +5989 4 22.0764 7.2366 29.8207 3.60587 3.07422 19.5812 +5990 4 22.5251 6.52709 28.5653 7.82832 -0.878326 -6.51175 +5991 6 6.87782 37.1389 6.94163 -1.13334 10.8563 13.3375 +5992 4 7.36847 37.9928 6.7949 -15.2779 -15.8129 7.53623 +5993 4 6.56156 37.0941 7.87645 12.8328 8.43507 -22.3513 +5994 6 37.1951 18.3599 16.3051 31.8484 54.3956 -63.0636 +5995 4 36.5686 18.6502 16.9278 -28.3708 4.63663 38.6073 +5996 4 37.3394 19.2548 15.8115 -3.93301 -42.965 18.1753 +5997 6 52.3874 25.498 31.3134 14.111 8.09505 3.74503 +5998 4 52.2596 26.4307 31.6656 16.8187 -33.1452 -9.3176 +5999 4 53.3531 25.244 31.2999 -24.6813 13.8962 6.4969 +6000 6 3.93514 39.8328 16.38 27.5969 -10.0907 -6.6773 +6001 4 3.11618 39.8354 16.8714 -5.56329 -11.6849 3.14974 +6002 4 4.25813 38.8985 16.2148 -16.7217 35.1377 3.93655 +6003 6 26.055 14.6352 18.3097 2.48745 23.0231 -5.4837 +6004 4 27.0121 14.5315 18.422 -4.58232 5.3017 0.111087 +6005 4 25.8831 15.6122 18.2324 0.591934 -25.1482 1.36918 +6006 6 22.1861 39.625 23.6336 -13.0035 -7.16992 22.0669 +6007 4 22.5756 40.4198 23.3178 20.0241 20.7615 -16.9022 +6008 4 21.775 39.9577 24.4575 2.36146 -17.5943 -7.81238 +6009 6 5.9827 12.8747 22.3739 5.28791 3.19174 -0.347139 +6010 4 6.16079 13.1981 21.4813 -0.557605 -0.80783 -0.954564 +6011 4 6.85402 12.6686 22.7296 5.64669 -4.60509 -1.11135 +6012 6 48.9358 28.1656 34.7093 -34.12 -15.1013 -7.57113 +6013 4 48.3009 27.4712 34.4428 -1.24475 21.7165 7.07681 +6014 4 49.7483 27.6911 34.6564 33.1581 1.27133 3.59264 +6015 6 7.76665 22.4378 33.2356 5.82113 4.36953 2.134 +6016 4 7.99414 22.0593 34.0982 -2.05459 -3.4103 -7.93698 +6017 4 7.15982 21.8587 32.7652 -2.05153 -2.03416 7.79212 +6018 6 41.0903 39.5994 11.7192 28.8485 25.6095 5.96672 +6019 4 40.6961 40.3697 11.3388 -29.9964 5.48828 -17.7316 +6020 4 41.854 40.0697 12.1081 -2.33823 -21.5528 5.66509 +6021 6 26.8801 37.922 39.3457 -9.67122 -13.15 30.7983 +6022 4 27.1418 37.9976 40.2903 -3.7646 7.48977 -14.0985 +6023 4 25.9915 37.5069 39.4007 11.6973 7.1772 -10.1587 +6024 6 16.8317 41.5399 16.7862 15.0313 6.40425 17.7164 +6025 4 17.5506 0.178386 16.4567 -5.24562 -1.69226 -13.3924 +6026 4 17.0965 41.4441 17.7156 -14.9292 -9.12078 -7.2801 +6027 6 19.02 8.9948 17.6728 1.01249 -20.0254 27.6053 +6028 4 18.8256 9.92734 17.8397 -2.50665 -0.780218 3.94781 +6029 4 19.0722 8.45531 18.5284 1.63313 22.2167 -34.6872 +6030 6 31.0993 24.379 20.1031 -5.45136 7.30173 -0.0135243 +6031 4 30.58 24.6604 20.88 7.69136 -4.59203 -13.2888 +6032 4 31.7465 25.0718 19.9526 0.652083 2.88804 -0.364555 +6033 6 24.6121 6.3117 27.596 -14.2942 3.47042 8.51555 +6034 4 24.6855 6.72112 26.7154 0.000835906 -11.6728 3.52597 +6035 4 24.4562 5.35726 27.5796 2.29956 0.742888 -9.80031 +6036 6 11.6309 5.33579 8.21245 48.3472 17.5789 -13.0214 +6037 4 10.7447 5.097 8.35577 -43.9811 -8.24091 9.59422 +6038 4 11.6324 6.14291 7.66014 -5.62825 -15.0071 6.92232 +6039 6 16.4828 34.2339 17.2467 58.9453 43.3211 -11.1422 +6040 4 15.833 34.737 16.7643 -22.9367 -4.06405 -2.05249 +6041 4 17.323 34.8225 17.0684 -41.083 -49.3458 15.3182 +6042 6 40.7431 40.4645 8.52128 12.2314 -11.8005 -21.5431 +6043 4 40.0246 40.6751 9.09883 -14.9736 5.2464 12.3608 +6044 4 40.4244 39.6664 8.05294 5.87539 10.603 6.78918 +6045 6 42.7463 5.87875 14.2877 12.74 -3.29305 -3.26541 +6046 4 42.0588 5.87807 14.9272 -15.1719 8.11415 20.4154 +6047 4 42.5132 5.11812 13.7588 -0.0411089 -3.23222 -11.0769 +6048 6 14.3659 21.065 6.06718 -46.5802 14.1632 25.7131 +6049 4 14.5381 21.6726 6.80844 -4.55135 -9.99097 -5.53618 +6050 4 15.2049 20.8313 5.76105 45.2018 -10.2131 -22.6687 +6051 6 16.2987 37.772 18.1217 -43.41 26.7654 24.2454 +6052 4 15.4242 38.2299 18.3727 36.2216 -25.3097 -28.3843 +6053 4 16.6845 37.7048 19.001 13.5629 -5.49997 -6.41318 +6054 6 40.7915 27.7152 27.1158 9.45156 2.81801 -4.91689 +6055 4 41.5456 27.319 27.566 -3.53201 -5.16081 10.0516 +6056 4 41.2155 28.2976 26.4751 -4.07016 3.79859 -1.40954 +6057 6 44.9595 25.9846 14.0499 3.3218 -15.4841 -8.79479 +6058 4 45.329 25.1566 13.6433 -5.22711 26.2877 13.1546 +6059 4 45.4837 26.7406 13.7529 4.37393 -9.76715 -6.45081 +6060 6 2.62066 33.9505 21.2427 -16.9582 -3.86849 -3.69815 +6061 4 2.06211 34.7496 21.3041 9.37305 -3.74186 4.79914 +6062 4 2.1388 33.3568 20.6382 5.47892 10.3925 4.65279 +6063 6 5.77806 4.43691 12.8378 4.70319 28.9306 -8.8144 +6064 4 5.36233 3.72198 13.3221 -5.81749 -8.58488 4.20714 +6065 4 5.80863 5.24637 13.3804 -1.3041 -13.5761 2.8333 +6066 6 16.8665 5.92021 7.40582 23.56 -3.08178 3.03829 +6067 4 16.4354 5.08697 7.20958 -2.89912 -12.7512 -7.28137 +6068 4 16.1638 6.54304 7.4701 -21.737 13.5702 4.65232 +6069 6 17.8259 38.4084 36.8446 -8.45971 28.6621 19.1884 +6070 4 17.7005 39.3712 37.0468 11.155 -18.7052 -15.1769 +6071 4 18.5325 38.3077 36.2071 4.43545 2.51623 -4.89916 +6072 6 43.3084 20.5973 5.4325 -39.7754 20.35 -2.23031 +6073 4 43.0204 21.5105 5.15286 19.9417 -23.843 3.70329 +6074 4 42.4274 20.1471 5.43024 22.0601 -2.53082 1.71294 +6075 6 21.5318 23.3 30.4444 10.3709 20.0389 -42.3415 +6076 4 21.0369 22.9394 31.1576 -20.9289 -4.03021 22.2109 +6077 4 20.911 23.6578 29.7428 10.7798 -15.246 22.7192 +6078 6 0.249866 28.0345 36.1724 -10.1983 37.6035 -27.6546 +6079 4 1.05324 27.7572 36.576 20.3102 -14.8665 16.9966 +6080 4 0.540234 28.832 35.6712 -10.982 -12.5736 6.41543 +6081 6 3.04754 17.0516 11.5683 -6.97145 7.64509 -15.3824 +6082 4 3.16434 17.3061 12.4746 3.36597 -0.550097 20.9912 +6083 4 2.52404 17.7798 11.2137 2.91457 -3.72579 -4.7217 +6084 6 24.1788 37.0366 23.9551 -12.9856 4.64226 12.2764 +6085 4 23.6099 37.826 23.831 6.85326 -8.75197 5.00341 +6086 4 24.4012 36.9865 24.9175 -1.53567 3.17074 -21.6248 +6087 6 3.95494 20.5134 27.4915 2.8093 53.7214 17.1103 +6088 4 3.58105 20.0931 26.7551 -14.7022 -26.8908 -38.8522 +6089 4 3.8118 21.4686 27.2477 5.25372 -20.6261 11.8203 +6090 6 54.8404 2.77723 29.6182 19.2518 19.5174 31.7291 +6091 4 54.8688 2.43537 30.559 -2.71579 12.5717 -24.6672 +6092 4 0.596183 3.44189 29.5911 -17.1059 -25.2514 0.407437 +6093 6 27.1931 8.41834 31.7378 -5.45838 77.4793 -29.1542 +6094 4 26.7872 8.25949 30.8671 -2.01983 -12.8877 1.93898 +6095 4 27.4107 9.43311 31.6496 -7.24897 -56.0438 21.5563 +6096 6 30.967 1.65521 30.3853 -24.4372 0.252197 19.6085 +6097 4 30.699 0.824835 30.0215 -2.04196 -23.8902 -26.6583 +6098 4 30.1085 1.94064 30.7387 6.28416 6.26069 6.0985 +6099 6 26.4053 36.4472 36.8445 23.7132 4.61357 6.55265 +6100 4 26.2095 35.8808 36.1068 -5.45287 -5.64468 -12.8873 +6101 4 27.3732 36.593 36.8324 -14.4493 2.44748 -3.93886 +6102 6 51.2993 10.0458 21.7014 24.6671 -30.2423 2.93053 +6103 4 50.7417 9.318 22.0589 9.26734 22.884 -6.07289 +6104 4 52.1551 9.59094 21.4448 -31.6711 18.7199 5.84467 +6105 6 52.4308 12.3792 23.2584 -6.42579 27.1004 22.8118 +6106 4 51.6946 13.0394 23.3088 16.6887 -7.91574 -6.77392 +6107 4 52.0327 11.5757 22.9611 -11.4365 -20.1199 -14.9439 +6108 6 9.99751 38.3699 20.6117 28.0449 -1.18219 -11.795 +6109 4 9.42862 38.2366 21.3654 -6.81781 0.619005 12.6857 +6110 4 10.9196 38.1916 20.8926 -11.789 -1.89114 -3.31064 +6111 6 22.7111 33.2651 0.632604 -8.26324 25.0772 17.5737 +6112 4 23.6702 33.3984 0.628432 0.752102 -10.2993 -4.51528 +6113 4 22.4939 32.4115 0.275412 2.14165 -18.6843 -11.1325 +6114 6 14.0859 40.8716 25.4956 -8.46488 1.55142 -11.4693 +6115 4 14.0599 40.7138 26.4427 12.1567 0.227551 5.06398 +6116 4 13.2623 40.45 25.1949 6.8133 8.32038 -2.55804 +6117 6 42.7734 15.0947 14.9538 14.4784 5.50426 -3.8277 +6118 4 43.0583 15.7694 14.2817 -8.42225 -24.0175 22.033 +6119 4 41.8405 15.2241 15.1238 -9.70916 3.613 0.791575 +6120 6 30.2327 7.231 8.54228 -3.22532 10.2874 -46.9304 +6121 4 30.2058 8.2102 8.45082 -0.363858 -13.9116 11.7844 +6122 4 30.4404 6.92219 9.39771 6.32383 2.81905 38.5597 +6123 6 3.37293 19.847 41.3038 28.0406 -0.792001 0.268463 +6124 4 3.19157 19.2836 40.5407 -0.0866071 4.98821 -2.30354 +6125 4 4.34764 20.0104 41.227 -24.6382 -4.50526 4.46777 +6126 6 8.87233 25.1482 17.2024 12.9182 -25.3276 -29.7935 +6127 4 8.99656 24.7585 16.2934 -10.9438 23.5455 20.5923 +6128 4 9.70028 24.8859 17.6216 -4.47076 0.166054 9.91948 +6129 6 9.34357 14.9539 22.0324 -26.1912 3.45279 3.87325 +6130 4 9.00509 14.8035 22.9321 4.97494 4.93375 -7.4516 +6131 4 10.1685 14.4775 21.9786 8.71262 0.391972 2.49596 +6132 6 2.03472 4.77693 20.8549 -5.0231 -16.4156 -4.2241 +6133 4 2.70086 5.4497 20.9192 18.9425 7.91266 2.94425 +6134 4 1.28907 5.15394 21.3146 -15.2358 3.90158 4.43282 +6135 6 18.286 7.04631 3.85489 -3.97091 0.415968 51.7005 +6136 4 18.7541 7.10917 3.04736 31.918 9.65669 -29.8899 +6137 4 18.8529 6.48913 4.44789 -12.6499 14.6692 -9.5202 +6138 6 17.0004 19.1661 19.8445 11.8294 -6.56912 -12.2376 +6139 4 17.7808 18.891 19.3473 0.445698 5.6808 3.33406 +6140 4 16.3387 18.5282 19.5337 -1.78106 12.0244 12.6463 +6141 6 4.30992 6.55322 21.357 27.1319 -4.11604 -15.0588 +6142 4 4.37542 6.91771 20.4543 -7.8574 5.76294 11.3657 +6143 4 5.24976 6.29093 21.5457 -28.1422 4.34799 0.417434 +6144 6 20.7778 36.9247 35.6618 12.7574 4.02765 2.49936 +6145 4 20.2864 37.0887 34.8562 -7.2468 0.0429553 -2.15645 +6146 4 20.2346 36.372 36.2389 -2.87094 1.27188 3.61263 +6147 6 4.73067 15.0203 31.2359 -10.2649 -12.7571 22.9725 +6148 4 4.37694 14.8342 32.1428 11.1861 -2.73027 -21.4712 +6149 4 4.72677 15.9733 31.1768 1.84417 11.2425 -7.2724 +6150 6 2.35535 1.23403 17.5726 17.2813 12.9738 -21.7174 +6151 4 3.03402 1.36527 16.8495 -17.2186 -13.1695 22.3246 +6152 4 1.92973 2.10387 17.6452 0.590267 -7.80147 9.6411 +6153 6 34.6252 31.5686 19.7984 -1.60729 -4.66139 0.568696 +6154 4 34.8929 31.9422 18.9439 4.49305 -5.18782 4.12596 +6155 4 34.4714 32.3271 20.3758 -2.9002 2.23803 -3.07041 +6156 6 24.1913 21.6089 13.5036 44.4004 0.328862 15.9674 +6157 4 25.0757 21.8297 13.9142 -30.8821 -6.11275 -18.7564 +6158 4 23.5519 22.0563 14.035 -11.4749 15.2668 7.23318 +6159 6 37.218 41.0972 5.69166 19.5034 -37.5651 -15.7416 +6160 4 37.88 41.7374 5.923 7.59407 13.6828 5.23653 +6161 4 36.3807 41.3769 5.99879 -24.6171 21.3167 5.70938 +6162 6 8.42841 7.99247 20.2345 27.9918 -33.0924 -23.0682 +6163 4 9.34968 8.06233 20.5347 -4.8675 5.92304 8.61954 +6164 4 7.93058 8.66586 20.633 -20.9635 39.4709 23.1164 +6165 6 14.934 18.8758 36.75 17.7625 18.3313 11.0559 +6166 4 14.0949 19.1945 36.41 0.856939 4.31409 -3.77921 +6167 4 15.6034 19.6084 36.7133 -18.5855 -12.9909 -4.44137 +6168 6 43.9791 40.6449 18.6524 7.41508 -0.428335 24.9958 +6169 4 43.9624 40.7544 17.7052 -3.16787 6.2189 -16.8328 +6170 4 44.8981 40.8188 18.9384 -9.62798 -9.77666 -5.30663 +6171 6 33.7986 32.259 37.3472 -15.5926 9.65631 -28.1821 +6172 4 34.0274 32.2295 36.4014 -5.19534 3.83485 15.8105 +6173 4 34.1945 31.4931 37.7276 18.2887 -12.3889 13.4194 +6174 6 5.09973 29.2834 24.0252 13.8314 -2.01249 29.2407 +6175 4 5.66693 29.5091 24.8044 -5.06459 -6.54793 -18.8628 +6176 4 4.76417 30.1245 23.7257 -5.49348 12.2693 -6.11875 +6177 6 33.6015 36.4179 10.971 30.294 2.53226 6.78363 +6178 4 32.7735 36.2836 10.5343 -15.5054 6.45725 -2.01925 +6179 4 33.4383 36.5424 11.9099 -7.56878 -2.98124 3.33663 +6180 6 28.3001 33.6166 13.1114 -3.16981 -41.1231 7.22112 +6181 4 27.986 33.7275 12.219 -4.10441 9.98298 -8.29397 +6182 4 28.0891 32.6746 13.2632 10.0083 14.4728 2.55385 +6183 6 6.1623 19.0624 24.2873 5.31394 -11.2621 -36.8053 +6184 4 5.95503 19.8074 24.8143 -4.51254 28.8134 22.7686 +6185 4 6.28788 18.3114 24.8476 4.1007 -18.6743 20.2695 +6186 6 28.4211 19.9362 1.86305 -4.43245 7.71948 8.08869 +6187 4 28.5604 19.4518 1.05094 6.94613 -11.0067 -8.65768 +6188 4 29.2593 20.0693 2.30859 5.46778 1.78077 -4.74455 +6189 6 42.0505 23.9714 9.55892 6.22877 26.0941 -5.00732 +6190 4 42.391 23.8165 10.4395 -2.03908 -8.00084 11.8727 +6191 4 41.7886 23.1541 9.15249 -7.7641 -22.6922 2.79783 +6192 6 43.5253 7.315 27.4414 4.48568 -18.9578 -0.168547 +6193 4 42.7359 7.07504 27.9388 -6.2009 1.74131 6.88183 +6194 4 43.2052 7.88335 26.7439 -2.31843 16.2411 -9.46916 +6195 6 20.4956 32.9945 9.25625 -63.2008 -2.41398 62.3431 +6196 4 19.7614 32.7323 9.96384 46.0698 -1.29529 -42.5223 +6197 4 20.3338 33.9485 9.24422 8.88758 3.29294 -12.4302 +6198 6 38.0318 35.2729 15.9427 -5.10059 -23.3836 -5.94715 +6199 4 37.3995 34.9842 15.2568 2.89047 3.01243 8.00796 +6200 4 37.9835 34.6007 16.6396 -2.13864 4.37071 -5.14357 +6201 6 47.5248 20.8808 3.95546 13.1177 31.1209 27.8573 +6202 4 48.0834 21.3954 3.36869 -6.69878 -8.89675 -13.1919 +6203 4 47.6052 21.4353 4.7772 -13.2785 -23.1226 -13.8569 +6204 6 10.9875 31.6892 41.4239 15.5099 5.40423 7.74084 +6205 4 11.658 31.8708 40.7529 -4.12469 -5.30401 -0.84079 +6206 4 10.1343 31.6927 40.9879 -7.96504 0.77506 -5.12071 +6207 6 43.245 12.6563 2.56138 15.9633 -17.8577 -2.60545 +6208 4 42.9226 12.9752 3.38765 -12.1061 12.2594 19.7928 +6209 4 43.9805 12.0851 2.8659 -6.2276 8.95994 -12.8364 +6210 6 49.4104 25.4124 21.1593 7.68799 -7.2912 5.83542 +6211 4 50.1422 25.2884 20.5387 -8.96396 0.548785 -4.3756 +6212 4 48.9554 24.5515 21.2297 -0.219253 8.20777 -2.75058 +6213 6 1.96484 34.1377 26.4635 6.42117 -7.58108 12.8955 +6214 4 2.78995 33.6488 26.6876 -20.6965 7.00883 -11.752 +6215 4 1.22498 33.5087 26.4121 8.61724 -1.18295 0.134997 +6216 6 17.1337 20.8362 36.6743 -37.6695 15.6036 21.8376 +6217 4 16.9634 21.7284 37.0778 2.65776 -21.0237 -14.9647 +6218 4 18.0617 20.7108 36.604 32.6572 -5.60583 -3.13187 +6219 6 36.5992 10.9735 3.70439 10.6975 8.82737 -5.2901 +6220 4 35.7369 11.4094 3.76988 -2.71865 -0.136466 14.5734 +6221 4 36.9547 10.7712 4.57736 -11.0261 -1.49358 9.11508 +6222 6 14.2213 20.6732 21.973 14.9521 39.3927 -42.8738 +6223 4 13.9206 20.2439 21.1689 -11.1282 -8.72354 1.45028 +6224 4 14.6851 21.4628 21.5779 -7.13343 -24.0966 22.8635 +6225 6 33.9052 12.2539 9.56536 64.6676 -19.1083 -72.943 +6226 4 34.3898 11.482 9.88615 -11.1791 5.59008 13.1859 +6227 4 33.2619 12.5422 10.1406 -48.1209 12.4396 55.8498 +6228 6 21.8075 41.4938 2.15247 -4.53434 0.170379 -15.7872 +6229 4 22.04 41.6038 1.2069 -3.47083 0.972349 16.0219 +6230 4 22.4007 40.8419 2.51679 12.4955 -1.6466 3.58022 +6231 6 20.9241 10.4413 14.2084 23.7182 11.537 17.3335 +6232 4 21.6155 10.8692 14.7979 -25.0251 -17.572 -17.464 +6233 4 20.772 9.54041 14.5736 6.4121 16.6732 -7.22543 +6234 6 6.25992 4.45494 24.6446 -20.993 10.5392 9.58783 +6235 4 6.70633 4.20365 23.8452 17.869 -10.7134 -15.0213 +6236 4 5.71116 3.71075 24.9084 -2.77077 -5.20552 -8.90983 +6237 6 50.776 14.5967 23.4784 31.7068 8.96229 10.5861 +6238 4 51.3012 15.0259 24.1918 -10.5702 -1.89466 -14.6802 +6239 4 49.902 14.4731 23.8252 -15.4415 -8.6063 7.51113 +6240 6 52.7906 13.9066 9.67243 -4.11462 48.2741 -4.64476 +6241 4 52.8606 13.0389 9.99278 3.823 -46.6932 12.5875 +6242 4 51.8698 14.0585 9.47707 -15.983 -0.946523 -10.048 +6243 6 9.04475 2.0467 29.9184 -38.5307 -30.621 -19.1189 +6244 4 9.46565 2.82007 30.2002 17.3321 39.2201 17.0183 +6245 4 8.08016 2.26538 29.8177 25.0495 -3.86709 2.38687 +6246 6 7.14389 29.9898 26.2407 4.70582 -42.771 12.4286 +6247 4 6.53112 30.404 26.8495 -5.08686 4.52864 3.1398 +6248 4 7.41427 29.1442 26.7142 -2.42767 26.6911 -17.7681 +6249 6 49.1638 41.7413 14.3375 -4.64089 27.4779 2.19815 +6250 4 49.5241 41.3828 13.5134 1.94418 -6.50091 1.47491 +6251 4 49.3811 0.802946 14.3236 2.14399 -30.2019 -5.07663 +6252 6 5.64888 3.82667 19.1906 -2.72189 -11.1411 26.1263 +6253 4 5.18678 3.36179 19.9258 5.23606 10.5823 -14.7259 +6254 4 5.05621 3.82399 18.4509 -7.60985 1.79477 -11.7277 +6255 6 9.32681 35.8274 24.8975 3.55565 13.5922 8.51546 +6256 4 10.2018 35.8152 24.4762 -3.06017 -4.39849 2.56743 +6257 4 9.46171 36.417 25.6586 -3.66837 1.49938 -3.23358 +6258 6 53.0285 29.7558 11.5499 -7.83487 -2.48558 9.64451 +6259 4 53.3653 30.4407 10.9686 7.5475 4.44921 -4.95089 +6260 4 52.7971 30.2083 12.3783 3.5824 -3.07517 -4.75195 +6261 6 22.6104 9.96627 5.67467 11.8622 1.90434 48.3765 +6262 4 23.3836 10.3266 6.15809 -8.36646 -10.9093 -7.81297 +6263 4 22.6398 10.3769 4.83333 -6.21393 7.91547 -32.804 +6264 6 39.5293 19.6134 2.67969 28.3515 9.20962 14.5311 +6265 4 38.5781 19.5068 2.58618 5.24604 -11.8744 -9.9137 +6266 4 40.0367 19.3939 1.87869 -17.6459 -1.04308 -3.70363 +6267 6 45.0742 35.5802 7.80399 12.9966 -1.00157 -13.6899 +6268 4 45.1073 36.2582 8.46111 4.45786 22.5875 10.9896 +6269 4 44.5296 34.9182 8.21469 -15.7495 -15.8794 0.100297 +6270 6 29.7829 14.2459 9.96531 -11.2509 -10.5838 -6.95263 +6271 4 30.0063 14.1556 9.0247 4.7074 -2.26926 1.20969 +6272 4 28.8478 13.9409 10.004 20.3358 11.6689 4.42407 +6273 6 29.2532 30.1489 21.8872 -22.7358 8.41186 19.7293 +6274 4 29.1261 30.8351 21.2312 3.02893 4.58934 -9.48892 +6275 4 30.0577 29.6729 21.7506 17.9631 -9.68935 -13.2514 +6276 6 11.1028 18.8149 6.56446 12.6172 11.1172 -5.75863 +6277 4 11.2898 19.7306 6.3073 -12.9819 2.38317 -1.53669 +6278 4 11.9922 18.4416 6.57196 0.724871 -8.7617 2.86424 +6279 6 13.403 39.1446 13.4748 19.5871 -11.9429 -30.0571 +6280 4 13.7697 39.8507 13.9939 7.8117 10.5151 13.4831 +6281 4 12.6292 38.8582 13.9386 -20.2152 -7.12839 8.32373 +6282 6 50.1432 12.9893 0.138872 33.4511 24.3017 64.4039 +6283 4 49.8497 12.6921 41.2405 -20.6967 -26.8999 -59.7452 +6284 4 50.7523 12.3231 0.503203 -9.52656 2.062 -3.94446 +6285 6 47.8312 31.3446 27.7846 -28.8076 12.8422 -13.2841 +6286 4 47.8833 31.94 28.5222 10.4006 4.03183 17.8143 +6287 4 46.9755 31.6479 27.4044 17.0933 -18.1054 -4.43643 +6288 6 27.7087 1.63781 7.50008 21.5285 -7.57238 -25.6841 +6289 4 26.9556 1.59549 8.05597 -25.0455 5.22958 17.9803 +6290 4 27.5166 0.963037 6.82134 -2.90509 7.89899 -0.0646572 +6291 6 54.8922 20.8 16.0331 4.1789 -41.4982 -7.93337 +6292 4 54.9282 20.9554 16.9716 0.186425 8.83729 15.9831 +6293 4 0.211633 19.8495 15.948 -9.91253 29.0383 -5.43741 +6294 6 37.4291 33.0056 34.4398 -14.0977 10.8622 -7.94924 +6295 4 37.2978 32.0826 34.6133 -1.58878 -21.6351 7.1631 +6296 4 36.5764 33.2755 34.0173 17.7258 4.45123 10.3439 +6297 6 19.5104 39.7742 6.7506 5.90241 -38.4201 -4.61078 +6298 4 19.1293 39.2182 6.01225 10.8403 19.9531 16.5545 +6299 4 19.9162 39.0938 7.35425 -12.9804 24.3225 -11.3083 +6300 6 32.4399 2.72699 8.06906 17.0773 23.4006 1.78158 +6301 4 32.9347 3.14941 8.81642 -19.9733 -16.2934 -9.37408 +6302 4 31.5531 2.49842 8.37658 0.516726 -6.41942 5.39598 +6303 6 12.9757 16.0915 4.06618 3.48233 -26.1302 -11.2272 +6304 4 12.5744 15.6527 4.83433 -0.695682 4.00385 -3.98901 +6305 4 13.3513 15.3473 3.55621 -4.30287 11.2057 5.6128 +6306 6 4.64677 29.9233 5.42983 -10.8182 14.2385 -56.8973 +6307 4 4.99957 30.1958 4.52107 -6.90737 -7.02982 36.161 +6308 4 3.86081 29.3683 5.18005 29.0195 11.7205 17.0104 +6309 6 29.7541 32.1122 24.0662 13.5325 13.0696 7.67536 +6310 4 30.657 32.2311 24.4313 -14.6232 -5.62961 -5.85099 +6311 4 29.8358 31.5529 23.3009 -2.99915 -14.1964 -7.88188 +6312 6 11.8689 30.6971 33.4711 -8.01032 -39.2081 28.7873 +6313 4 11.8961 29.8478 34.0479 -0.904256 41.1124 -29.4381 +6314 4 12.7288 30.7703 33.0546 6.62137 -3.78113 1.33903 +6315 6 17.3676 40.4123 27.3051 45.9752 30.8726 -27.1152 +6316 4 17.3095 41.3718 27.4557 -2.78012 -6.90788 -0.219066 +6317 4 16.6513 39.9873 27.6906 -54.0346 -15.2197 27.4879 +6318 6 8.66734 4.89901 8.93063 6.14116 -5.58058 -4.6479 +6319 4 8.35347 5.40804 8.18272 -1.2331 1.82325 -6.13974 +6320 4 8.16334 5.22925 9.67691 0.199365 1.34734 7.84993 +6321 6 39.5604 17.6833 9.57201 22.5105 -50.1639 -23.667 +6322 4 39.2658 17.6048 10.464 -10.5204 8.51393 23.2154 +6323 4 39.725 16.7168 9.31019 -10.6666 45.7312 -1.86495 +6324 6 31.4955 30.1755 28.5516 10.628 -19.507 17.1882 +6325 4 32.3525 30.3948 28.1778 -6.71462 8.32315 -8.11857 +6326 4 31.74 29.3729 29.0438 -14.9082 5.37925 -0.357203 +6327 6 52.6685 19.2672 40.0663 9.25056 16.4026 -20.0757 +6328 4 53.0106 18.7322 39.321 -9.61724 -4.6138 17.4516 +6329 4 53.0677 20.1385 39.8955 -5.74465 0.792691 -1.74468 +6330 6 3.24164 7.81666 9.85998 28.0429 9.66948 1.15728 +6331 4 3.83019 8.53432 10.2304 -23.9275 -17.8293 -12.7584 +6332 4 3.84853 7.29279 9.3074 -9.38214 5.4782 3.90821 +6333 6 23.129 35.218 35.5945 -25.4929 1.01472 15.9258 +6334 4 23.7784 35.3391 34.9359 33.2897 3.00284 -24.4901 +6335 4 22.5015 35.9398 35.4197 -4.85807 -5.03855 8.29984 +6336 6 19.51 14.0653 20.8221 -35.7596 -3.44758 -1.61502 +6337 4 19.8587 14.4985 21.6011 13.4146 6.44294 7.16022 +6338 4 18.5274 14.0852 20.9637 18.4505 -1.93413 -5.69736 +6339 6 23.6205 15.8624 24.0207 6.44012 -27.6666 -1.73497 +6340 4 23.7023 16.8084 24.0387 5.71305 22.1977 -2.17526 +6341 4 24.4604 15.4749 23.6823 -15.4387 15.2983 3.34328 +6342 6 0.280487 30.496 6.10097 2.10248 14.5258 38.6463 +6343 4 54.969 30.1752 5.28655 -5.78718 -18.1599 -43.8305 +6344 4 54.4568 30.8162 6.51538 2.11893 2.60892 6.09244 +6345 6 4.88818 13.213 29.1211 -10.1066 -44.834 -24.7823 +6346 4 4.81121 13.8494 29.7943 -5.77674 34.7781 35.8081 +6347 4 5.65875 13.4519 28.6173 14.302 5.76116 -10.624 +6348 6 54.2113 27.2762 19.1921 -15.5686 -30.3542 31.9917 +6349 4 0.068746 27.3681 19.6083 11.8738 0.793184 4.88761 +6350 4 54.2438 27.8077 18.4285 0.565084 22.1088 -37.313 +6351 6 13.9147 35.7477 9.19539 -9.45761 -42.0549 -30.4782 +6352 4 13.6498 35.0288 8.53341 12.0253 23.1831 27.3793 +6353 4 13.9217 36.5134 8.63033 3.91359 16.7787 -6.83247 +6354 6 5.91895 31.9062 18.8199 -10.5522 26.6577 -12.1166 +6355 4 5.59368 32.8276 18.7738 -3.70357 -9.82177 15.0022 +6356 4 6.3357 31.8271 17.9661 5.53766 -12.0386 -9.76018 +6357 6 5.80079 28.8629 9.48582 -4.23387 2.66619 -7.91216 +6358 4 5.1492 29.3316 10.0156 -4.194 3.81529 3.65919 +6359 4 5.26808 28.2356 8.96551 5.75879 5.11243 0.385299 +6360 6 40.1186 6.06288 9.7252 27.6823 -14.9678 -34.8134 +6361 4 40.0604 6.61837 8.91786 -4.97866 -6.72317 19.9534 +6362 4 40.8451 5.41953 9.46609 -26.5422 19.2978 14.9684 +6363 6 20.3249 13.4665 41.4109 48.5393 0.491453 -34.6424 +6364 4 21.248 13.7047 41.7262 -35.6043 -9.97545 -2.58991 +6365 4 20.4078 13.625 40.4256 -17.6073 -2.89865 23.6593 +6366 6 14.4355 21.7431 27.3521 26.8888 -5.93952 12.1752 +6367 4 15.3929 21.7238 27.5426 -15.4302 4.65814 3.66232 +6368 4 14.4086 21.5632 26.4128 -6.38145 3.02673 -3.91912 +6369 6 38.7552 1.80385 30.0529 11.0268 -28.3612 -27.359 +6370 4 38.4475 1.96331 30.9218 -11.1335 10.8767 32.3314 +6371 4 38.864 2.66369 29.6567 5.01485 14.1269 -3.82072 +6372 6 5.6038 10.8537 14.1812 -8.02182 -19.6512 10.0037 +6373 4 4.967 11.5707 14.1035 -3.71772 1.30399 -2.93081 +6374 4 5.11243 10.0991 14.6 11.6474 17.9462 -13.8385 +6375 6 45.4185 36.7135 27.9228 -18.8199 18.417 -42.2307 +6376 4 46.0687 36.7087 28.6222 8.21134 6.27257 3.16342 +6377 4 45.7172 37.2784 27.1471 -3.80026 -24.227 32.4306 +6378 6 54.0799 35.0377 20.3974 -0.144446 0.236923 -11.8112 +6379 4 53.8476 34.1116 20.536 0.519878 -4.41527 -2.37245 +6380 4 53.9532 35.2077 19.4441 0.866973 -0.817495 13.7238 +6381 6 42.0671 14.221 28.4749 -2.16655 -3.30611 3.54679 +6382 4 41.9442 13.9043 29.3971 9.00113 8.16851 -11.079 +6383 4 42.9986 14.4434 28.31 -2.56617 -4.72525 9.98454 +6384 6 34.845 7.68802 26.7053 1.50556 20.2543 7.34306 +6385 4 35.7046 7.39142 27.0344 -1.60005 -9.47728 3.59716 +6386 4 34.4934 7.05976 26.0702 4.4346 -10.8207 -3.70702 +6387 6 49.6605 30.7141 23.8514 -28.5275 -6.56067 -11.9374 +6388 4 50.4604 31.1934 23.8565 34.1351 17.5516 -0.640456 +6389 4 49.8146 29.9659 24.4072 5.37992 -19.8924 15.651 +6390 6 50.8948 7.80148 14.1671 21.5777 -12.9452 34.2787 +6391 4 50.8247 6.96775 13.7105 -4.99079 -12.0182 -18.7136 +6392 4 50.5655 8.51894 13.6572 -15.7049 17.9748 -24.3233 +6393 6 4.26893 39.4826 27.8512 8.9926 -8.51629 -1.47833 +6394 4 3.65831 40.2241 27.8513 -3.04259 7.34368 5.94949 +6395 4 4.00328 38.958 27.1013 -12.9816 -10.5728 -11.1653 +6396 6 8.75177 32.8341 8.22283 -21.5639 -30.1985 -34.1316 +6397 4 8.2383 32.1284 7.72694 10.6374 17.547 21.6449 +6398 4 8.83279 33.5372 7.56693 3.76401 9.53239 7.06969 +6399 6 52.9594 25.4882 9.38297 -25.0802 50.1357 20.0056 +6400 4 51.9882 25.4292 9.65119 35.7509 1.27265 -17.7678 +6401 4 53.158 26.4759 9.49827 -6.53976 -44.9947 -5.62964 +6402 6 29.5661 36.7256 19.4603 5.44621 -17.3757 32.4066 +6403 4 29.5786 37.3961 18.7906 9.88328 7.74732 -15.4263 +6404 4 30.4565 36.6309 19.8726 -14.3545 4.38723 -10.5986 +6405 6 52.3236 36.1013 25.1169 17.8415 -25.8683 -35.0149 +6406 4 52.9656 35.7372 25.71 20.0999 5.67458 7.00157 +6407 4 51.6595 36.4261 25.6714 -35.904 19.3861 23.0835 +6408 6 21.182 15.7103 31.1872 -18.8583 3.19523 -20.0756 +6409 4 20.6533 16.2005 30.5215 19.2403 -4.60119 13.454 +6410 4 20.518 15.2243 31.6931 2.46505 1.20146 2.10658 +6411 6 10.6569 22.4337 39.4531 2.51655 -26.4213 -37.4968 +6412 4 10.8327 22.4219 38.4645 -4.29248 9.16844 28.2769 +6413 4 10.2506 21.5589 39.6181 7.08653 12.2011 0.686531 +6414 6 25.1113 11.6729 22.7164 -12.9971 -0.576423 -18.0399 +6415 4 25.1382 11.4787 23.6279 21.2779 0.00518046 39.517 +6416 4 24.1824 11.5118 22.5586 2.84555 -0.272219 -17.8246 +6417 6 31.7896 10.4703 2.90217 -23.2712 -10.1944 -9.79051 +6418 4 32.6146 10.7499 3.28348 13.8778 6.97942 -8.99307 +6419 4 31.8394 10.4464 1.92418 10.0551 5.29594 18.2662 +6420 6 52.4849 36.4361 22.1663 -9.62786 -33.6069 5.21212 +6421 4 53.146 36.0606 21.5474 -12.5852 0.946736 4.3316 +6422 4 52.0694 35.6392 22.6209 17.7505 30.3514 -16.202 +6423 6 46.2093 40.0329 26.9877 0.0297183 29.9961 33.6049 +6424 4 46.4751 39.2742 26.5126 9.55695 -26.8643 -22.4205 +6425 4 45.9048 40.7092 26.3771 -3.76152 -2.91476 -3.34389 +6426 6 24.0885 36.7218 39.1011 7.12362 -3.16907 -4.80429 +6427 4 23.5999 35.9078 38.9667 11.8985 -11.6148 -5.9332 +6428 4 23.4559 37.2234 39.5891 -11.7402 16.6095 17.3029 +6429 6 22.3514 7.42547 31.8169 -35.2707 -41.8068 15.3628 +6430 4 22.2213 8.33277 32.0647 5.94025 21.3422 4.40196 +6431 4 21.6465 6.92073 32.3398 32.1745 21.6054 -24.7594 +6432 6 14.3502 18.3597 4.09728 -2.0055 -9.38358 23.348 +6433 4 14.1099 17.4219 3.93107 -0.92654 19.6042 10.3569 +6434 4 14.0726 18.5364 5.03654 13.0175 -10.3464 -23.9346 +6435 6 27.3175 38.46 0.124188 33.1007 -9.911 1.68747 +6436 4 26.9395 39.2806 0.463932 -4.88512 2.40457 5.81864 +6437 4 28.2608 38.413 0.45438 -35.2324 2.96259 -2.16122 +6438 6 18.6695 0.162292 12.2239 -43.166 1.81748 26.3235 +6439 4 17.7303 0.262878 12.5713 26.4571 2.30278 -22.2908 +6440 4 18.9433 41.3202 12.7499 8.63834 -11.46 6.42912 +6441 6 49.423 24.9792 25.3382 20.605 1.42964 -0.346179 +6442 4 48.5484 24.7002 25.6009 -12.613 -0.556076 -3.92373 +6443 4 49.3508 25.8032 24.8352 -9.8769 -5.62219 -3.2466 +6444 6 52.0685 20.2858 15.7446 -45.9435 -8.75518 14.7384 +6445 4 52.9731 20.5149 15.783 39.268 6.79994 2.42829 +6446 4 51.7449 20.2597 16.6676 4.81444 3.79951 -9.92674 +6447 6 49.6576 15.6472 38.4942 19.425 -17.6129 -0.00729052 +6448 4 49.2099 16.0165 37.7231 -6.98596 1.36616 -1.50856 +6449 4 49.5102 16.1958 39.2633 -14.7214 13.7889 5.58845 +6450 6 15.9211 23.7235 13.4193 23.3289 -36.8815 11.3263 +6451 4 16.506 23.7025 14.2147 -19.633 8.70021 -19.3267 +6452 4 15.5217 24.5725 13.2813 -7.62789 19.6624 11.7876 +6453 6 14.3566 29.1635 14.3074 -12.0826 22.9902 -11.8551 +6454 4 14.1263 29.6193 13.4563 6.10678 -19.1115 21.2229 +6455 4 14.1254 29.8374 14.9735 4.9154 -5.66101 -4.10969 +6456 6 30.4264 19.8612 16.8883 21.8822 -42.1222 -1.02119 +6457 4 30.7186 19.5182 17.7453 7.89699 4.38367 -1.56912 +6458 4 29.8579 20.5689 17.0557 -25.7709 36.069 4.20145 +6459 6 21.3137 21.0352 23.1207 17.1515 -0.95565 24.203 +6460 4 22.2175 21.149 23.495 -16.5785 2.35003 -9.75668 +6461 4 20.7278 21.0809 23.8918 1.9436 3.71589 -4.02445 +6462 6 32.3543 0.425745 25.2542 2.91189 -3.53517 -15.1456 +6463 4 32.2281 0.339162 24.2978 10.7775 -1.18886 4.59452 +6464 4 31.5305 0.792307 25.5362 -21.0885 6.89421 14.2132 +6465 6 26.144 32.4145 27.5224 1.5207 15.2147 0.716215 +6466 4 25.5792 33.1636 27.3089 1.00017 8.92672 2.49827 +6467 4 25.8737 31.7446 26.908 1.40169 -15.6227 -12.5261 +6468 6 31.6924 23.0038 41.4488 2.9891 4.25247 18.5975 +6469 4 32.5817 22.7219 41.7427 -10.6129 2.19465 -7.80737 +6470 4 31.0787 22.7203 0.234806 2.54762 2.31931 -6.22567 +6471 6 54.3675 17.8383 10.7129 6.79577 23.0573 52.4548 +6472 4 53.55 18.2477 10.4428 -14.1319 6.62767 -11.4304 +6473 4 54.6119 17.1874 10.0964 4.54612 -26.2874 -33.1105 +6474 6 15.4111 28.5567 8.624 -23.5209 17.7221 -14.2225 +6475 4 14.7074 29.0083 8.07604 23.4242 -18.2482 9.63627 +6476 4 15.9053 27.9212 8.07642 -10.4486 8.35345 -4.07335 +6477 6 21.923 22.3267 27.6697 4.39763 -15.072 3.90508 +6478 4 22.0757 23.261 27.7591 9.36727 14.8743 -6.39222 +6479 4 22.0153 22.013 28.5729 -4.02641 -8.91923 4.38679 +6480 6 2.936 17.0367 8.13301 26.8737 -0.816539 -9.93732 +6481 4 3.80704 17.1417 7.69888 -17.5309 -13.2134 -6.39661 +6482 4 2.90872 17.8246 8.6543 -8.08771 15.2208 15.3377 +6483 6 27.578 18.2783 3.98106 42.3665 -21.0645 -7.59535 +6484 4 26.9838 18.9866 3.87461 -35.9411 25.5305 -3.32845 +6485 4 28.3853 18.6252 3.56495 -11.0807 -10.9366 8.58166 +6486 6 24.7671 24.5333 8.4671 -3.55267 7.94183 -11.8318 +6487 4 25.0347 23.6359 8.24775 3.17664 -3.45343 1.13667 +6488 4 24.5725 24.5372 9.40731 3.34714 4.39373 0.466573 +6489 6 41.9868 30.4684 13.7801 28.6364 -21.7839 2.09937 +6490 4 42.9472 30.4515 13.6527 -5.43777 20.4489 -0.76134 +6491 4 41.8419 29.5153 13.705 -23.7897 6.87836 6.63004 +6492 6 15.6883 34.6775 41.5701 28.3539 0.757195 5.77675 +6493 4 16.4499 35.2822 41.5481 -1.40988 -1.74654 9.10263 +6494 4 14.9914 35.2483 41.869 -21.9895 7.57474 1.73196 +6495 6 11.1473 19.7636 40.5906 -7.01786 -3.24743 -12.0486 +6496 4 12.0915 19.8265 40.3679 -7.75233 -10.0339 3.8807 +6497 4 10.7912 18.9088 40.243 10.6872 10.1147 9.9033 +6498 6 47.4955 34.5311 14.2936 14.7321 -31.661 -1.66099 +6499 4 46.9342 35.3117 14.2317 -6.87541 2.2103 -19.2779 +6500 4 47.4978 33.9137 13.4978 -3.14061 27.4792 16.9676 +6501 6 12.3981 26.9866 28.4861 26.5251 -74.1409 -7.08463 +6502 4 13.226 26.8461 29.0045 -10.1246 11.0422 -0.548558 +6503 4 12.3843 26.0988 27.9797 -6.45597 45.1087 15.272 +6504 6 27.6352 16.207 39.8297 -11.2321 14.8168 6.13397 +6505 4 27.2166 15.4175 40.1567 -13.0977 -6.13948 14.8525 +6506 4 28.2209 15.8539 39.184 23.7477 -3.37658 -20.6816 +6507 6 33.4012 31.2187 27.2758 -9.34358 5.5086 -22.6345 +6508 4 34.125 31.7676 27.5967 0.31405 7.14405 -9.79506 +6509 4 32.8978 31.7031 26.5666 21.3968 -7.09575 17.214 +6510 6 39.0983 39.5786 31.9234 0.802497 -2.15341 -0.194752 +6511 4 38.8245 39.6381 30.9898 -0.836727 0.773065 10.2743 +6512 4 38.5517 40.2102 32.4207 8.13236 -5.11153 -2.10971 +6513 6 22.8875 16.5662 19.9556 -18.6429 -47.4181 0.677292 +6514 4 23.2714 15.7467 20.3471 4.73069 19.3315 1.98369 +6515 4 22.0725 16.1814 19.5628 10.6014 14.9969 -2.71875 +6516 6 23.9725 21.8734 10.5896 -27.2099 14.1239 -19.8382 +6517 4 22.9807 21.8764 10.5048 23.1264 -0.860286 11.7265 +6518 4 24.1883 21.166 11.1844 -1.51334 -13.3572 20.4185 +6519 6 40.1791 25.4384 2.79385 3.27033 10.4385 -27.7191 +6520 4 40.1215 24.9503 3.60378 -1.57927 -2.0951 21.761 +6521 4 39.8421 26.3422 2.89187 -4.34677 -6.39915 11.9951 +6522 6 15.0222 19.7637 9.4145 -47.1416 28.5942 15.5409 +6523 4 14.7277 20.7258 9.2944 13.9352 -33.0223 -5.4956 +6524 4 14.1981 19.3167 9.80349 37.3596 11.4933 -12.2096 +6525 6 7.16734 24.8761 0.122492 -38.9593 -14.3052 4.78001 +6526 4 7.92262 24.7355 41.4818 28.9246 2.82935 -8.29154 +6527 4 7.37325 25.3267 0.937782 12.1222 2.94845 5.10402 +6528 6 43.395 10.8961 31.3295 35.6095 27.14 14.9602 +6529 4 43.8689 11.0333 30.4778 -14.9331 -12.4968 13.4948 +6530 4 44.125 11.0026 32.0067 -24.5429 -5.74221 -22.764 +6531 6 13.8447 19.0699 27.8622 -3.35019 15.2359 -6.83255 +6532 4 12.9833 18.7163 28.0985 -4.55464 1.4506 5.93475 +6533 4 13.7874 20.0538 27.8435 3.60016 -14.5834 0.921784 +6534 6 3.48728 19.5892 9.61273 -55.7314 7.48447 -10.4955 +6535 4 2.69835 20.0905 9.96963 22.9021 -19.0673 -4.76373 +6536 4 4.2501 19.9102 10.0538 23.4289 5.03115 15.3445 +6537 6 51.0169 19.4212 7.7195 26.3048 39.1054 -53.7154 +6538 4 50.748 20.2575 7.21364 -2.7273 -32.3506 28.7892 +6539 4 51.8579 19.2204 7.21263 -29.2082 -7.0208 18.9647 +6540 6 42.2149 2.6091 10.4112 25.8935 -20.0624 -18.8025 +6541 4 43.1623 2.45904 10.6444 -24.152 11.2038 4.82319 +6542 4 42.1853 2.33112 9.4647 -3.80011 10.6068 21.7004 +6543 6 30.7928 6.43901 35.1986 -21.6247 -20.8821 1.11778 +6544 4 29.8295 6.39304 35.3716 10.0359 5.79706 -2.44011 +6545 4 31.0478 5.50645 35.0814 0.649811 9.90023 -1.69835 +6546 6 52.8722 36.96 18.5947 9.01539 9.27494 -7.55423 +6547 4 52.0657 36.4448 18.5061 -12.9065 3.13675 2.3407 +6548 4 52.6935 37.8522 18.2226 2.03776 -15.609 7.12003 +6549 6 44.2018 6.29599 1.04883 9.29405 17.1768 7.51252 +6550 4 44.5044 7.06671 1.58929 -4.49779 -17.4812 -0.431191 +6551 4 44.952 6.10526 0.487985 -0.115844 -2.61588 -3.46335 +6552 6 42.1326 38.6047 31.1849 18.5327 -13.3283 33.8135 +6553 4 41.7834 38.9864 30.4106 -14.9936 10.8543 -35.8121 +6554 4 41.4904 38.8324 31.8627 -0.641051 1.33351 1.93 +6555 6 43.7219 12.8013 9.05519 -6.282 7.91343 -40.7352 +6556 4 43.3171 13.69 8.87718 10.3632 -22.6116 8.3507 +6557 4 43.9578 12.415 8.15014 1.61383 14.3586 37.3488 +6558 6 13.4062 0.438838 6.51561 -30.6084 29.4042 -0.600484 +6559 4 12.9719 1.14899 7.05573 20.0807 -17.3818 -8.1595 +6560 4 13.3782 0.782754 5.59696 2.59294 -3.03922 8.63079 +6561 6 16.1217 13.2907 10.2805 -3.10591 -25.3511 -12.454 +6562 4 16.8946 12.7568 10.5076 8.02861 4.25978 2.86397 +6563 4 15.5299 12.6092 9.88546 -0.135156 17.9383 7.81515 +6564 6 1.59113 8.48217 4.69745 0.410151 -22.2633 16.3582 +6565 4 1.97054 9.1194 4.11301 8.92831 16.113 -22.7699 +6566 4 2.26765 8.43533 5.38895 -6.97239 3.0759 6.50405 +6567 6 37.2935 1.72102 10.5172 -13.7439 -9.21578 15.0824 +6568 4 37.1042 2.64553 10.595 10.0955 20.4226 -13.0857 +6569 4 36.8105 1.41855 11.2983 8.13599 -13.5394 -0.658926 +6570 6 53.8411 9.88961 17.6933 -45.7386 -38.9159 3.57486 +6571 4 54.5353 10.0399 17.0846 27.4782 6.59889 -23.5339 +6572 4 53.3721 9.08338 17.329 10.482 22.3983 14.0606 +6573 6 45.4787 30.6173 15.8038 -24.3966 -4.27047 13.1326 +6574 4 44.7717 31.1876 16.1963 22.3351 -9.42651 -10.1125 +6575 4 45.1907 29.6979 15.9324 6.84487 10.052 -2.21901 +6576 6 39.9241 16.6394 33.8426 -26.8877 -6.37158 -14.218 +6577 4 39.1549 17.2016 33.5476 23.291 -18.1751 3.42158 +6578 4 39.818 15.753 33.3934 2.94846 26.4583 15.0268 +6579 6 32.8532 24.7638 27.9368 9.55773 21.8346 -14.3088 +6580 4 33.6229 25.0593 28.4772 -14.6217 4.84572 -15.4057 +6581 4 32.6055 25.4822 27.2751 14.9958 -18.2832 35.5187 +6582 6 7.86628 31.6164 24.1091 22.2934 14.9204 62.1634 +6583 4 7.77595 30.8628 24.7489 -5.82572 16.0022 -25.8365 +6584 4 8.17309 32.3545 24.746 -24.9312 -26.1857 -42.8493 +6585 6 43.5324 41.3356 15.8165 16.5067 -5.02973 0.188395 +6586 4 43.1944 0.320073 15.7896 -5.69638 5.43212 -4.38793 +6587 4 44.429 41.3992 15.443 -10.6291 -2.88383 0.315207 +6588 6 20.021 29.5505 33.1902 25.0419 -7.98688 14.3875 +6589 4 20.8911 29.4069 33.5992 2.6372 -12.3274 -8.42754 +6590 4 19.6576 30.1636 33.8147 -14.9588 14.7065 -0.197692 +6591 6 43.4056 21.4569 18.6265 10.2156 -2.1017 15.5441 +6592 4 43.0498 21.3696 19.5313 -0.699705 -7.60676 -10.3888 +6593 4 42.9844 20.831 18.0298 -12.2248 -1.50447 0.773582 +6594 6 3.43117 19.1215 18.408 34.3393 4.70286 11.768 +6595 4 3.22621 20.0564 18.4267 -2.18643 4.81974 -5.59269 +6596 4 2.60088 18.6799 18.3703 -20.3233 -14.3491 -1.28903 +6597 6 41.6742 38.1112 16.3299 0.384784 -42.0766 -46.2559 +6598 4 41.8939 37.3404 15.6708 -9.75075 44.1094 34.3099 +6599 4 42.3403 38.1083 17.0131 5.25517 -2.87066 6.28124 +6600 6 7.56339 36.3915 10.5048 -18.8567 -13.4705 -13.5944 +6601 4 6.70677 36.1596 10.0967 9.18231 15.0261 0.193132 +6602 4 7.92251 35.493 10.5558 6.04756 10.3771 12.1048 +6603 6 36.2642 19.1103 34.8187 -40.4108 -29.7457 -43.4097 +6604 4 35.4719 19.3187 34.2477 20.3247 -4.92751 27.2967 +6605 4 36.4213 19.8813 35.3193 7.80254 33.8099 20.7293 +6606 6 53.576 24.9483 12.6399 1.20561 -0.517111 -17.326 +6607 4 53.6619 25.9414 12.669 8.79141 -29.2645 -7.24265 +6608 4 53.913 24.5623 11.7782 -4.09912 18.2899 28.1509 +6609 6 31.6824 10.4618 21.0892 -21.9557 -25.3726 -8.81809 +6610 4 31.4281 9.67391 21.5915 5.84781 10.5911 6.7189 +6611 4 30.8909 10.5838 20.5303 11.506 8.60894 0.332243 +6612 6 18.1093 28.7861 17.1823 13.2379 18.2354 -13.1758 +6613 4 19.074 28.7105 16.9739 -24.5165 5.38082 5.29014 +6614 4 17.7652 29.607 16.728 11.5472 -26.6353 13.0333 +6615 6 21.6834 18.2239 36.88 17.2587 0.811675 -5.67627 +6616 4 22.5671 18.027 36.4721 -27.7349 -1.55215 19.1593 +6617 4 21.6367 17.7543 37.7464 -1.70499 5.95625 -12.509 +6618 6 25.0551 19.0348 34.2287 -62.1041 -5.07763 23.2016 +6619 4 24.7663 18.3443 34.8719 5.43786 16.9757 -10.9409 +6620 4 25.8827 18.7578 33.9618 64.2031 -27.8273 -22.1538 +6621 6 15.5709 13.019 5.5539 0.00735057 -17.6807 20.5563 +6622 4 15.9927 13.3293 6.36292 0.0692085 12.4919 -5.39058 +6623 4 15.4491 12.0681 5.73828 -2.05735 13.2604 -17.7033 +6624 6 54.47 41.6402 14.7959 12.609 -13.6787 23.2741 +6625 4 54.8097 41.4531 15.6947 -1.45983 11.4249 -10.5768 +6626 4 53.7709 40.9948 14.7271 -15.6812 0.146288 -8.92901 +6627 6 1.6639 26.4809 31.3827 12.672 -25.15 69.1319 +6628 4 2.55491 26.3764 31.7735 -12.447 -0.333387 -5.00094 +6629 4 1.81595 26.6127 30.4938 10.6163 16.8649 -70.5286 +6630 6 32.3417 37.2868 29.6843 -28.8191 13.9029 5.49332 +6631 4 31.5776 37.8992 29.8843 22.0104 -18.6347 -4.04342 +6632 4 33.1171 37.6855 30.0945 4.79121 1.59444 1.77014 +6633 6 52.7104 21.0422 22.8867 -25.9211 15.4876 17.6965 +6634 4 51.8895 21.5407 22.5959 27.9099 -16.7396 2.24416 +6635 4 53.1785 20.6742 22.1421 1.33026 -7.16251 -14.9349 +6636 6 32.7465 28.5808 40.5193 19.5614 -2.95666 4.13778 +6637 4 32.1272 29.2507 40.2236 -19.1805 -2.02865 5.11045 +6638 4 32.5793 28.3106 41.4408 -7.78706 5.87783 -13.0149 +6639 6 23.6078 32.0654 16.3528 6.52471 10.7856 29.7964 +6640 4 24.3701 32.0729 16.9793 -11.8963 -10.2614 -20.8491 +6641 4 22.8856 32.382 16.9256 -1.99185 -7.37994 -15.8659 +6642 6 37.5296 9.17182 29.9714 -32.9897 5.30306 10.5453 +6643 4 36.7716 8.86544 30.5111 15.5785 -5.70066 -5.7121 +6644 4 37.1221 9.9689 29.5744 15.1662 -5.45151 -1.53858 +6645 6 2.26386 24.3835 14.5546 6.71022 -7.72281 -24.2479 +6646 4 1.85963 24.0133 15.3587 -6.19133 3.33276 -9.20692 +6647 4 2.05254 23.8227 13.7642 -0.610841 12.6744 29.5344 +6648 6 27.3686 28.7935 24.7702 8.50672 -13.2399 -34.495 +6649 4 27.2338 28.4442 25.6457 -6.20833 -8.14759 12.6395 +6650 4 27.3624 28.0447 24.1031 3.25167 21.2409 25.246 +6651 6 16.785 2.54959 14.3094 -6.20571 44.0359 18.8502 +6652 4 17.7332 2.53792 14.3228 12.8455 -14.2273 -3.64568 +6653 4 16.4133 1.8101 13.8617 -1.35631 -25.1723 -17.3636 +6654 6 21.8048 39.8028 36.8143 34.4281 41.1875 6.43987 +6655 4 22.7768 39.6281 36.9504 -24.2083 -5.20947 -5.56999 +6656 4 21.4132 39.0119 36.5213 -11.0202 -42.2818 -12.3994 +6657 6 14.0639 6.48367 41.5586 -1.33856 -25.5903 -39.7582 +6658 4 14.9412 6.10051 41.3922 2.86672 3.38346 15.7648 +6659 4 14.0719 7.05039 0.399753 4.3465 12.2327 22.8772 +6660 6 14.5548 16.5075 9.32956 22.0841 -14.7784 -21.2506 +6661 4 15.3586 16.5914 9.87503 -6.36199 2.72911 -6.08794 +6662 4 13.8899 17.0883 9.65711 -8.71884 14.1475 23.1102 +6663 6 8.67066 23.4815 30.5556 -44.0195 -7.59097 13.7496 +6664 4 9.49671 23.6557 30.1334 33.8338 1.75787 0.0184994 +6665 4 8.69311 23.4014 31.5307 16.0679 1.7618 -7.5699 +6666 6 37.6567 2.07706 19.9993 -10.7882 4.4912 14.9507 +6667 4 36.977 2.26584 19.3592 -1.31755 -8.36894 -24.369 +6668 4 37.311 2.65872 20.6865 17.7477 -2.01295 10.0374 +6669 6 42.7201 7.55732 8.02256 37.7013 -31.8103 68.6738 +6670 4 43.2078 7.90139 7.31041 13.9641 18.3531 -33.1003 +6671 4 43.4713 7.36984 8.74143 -54.3005 13.1784 -34.8973 +6672 6 38.5678 29.6657 6.85728 10.4727 -7.97498 12.0381 +6673 4 38.5138 29.2192 7.70857 5.95943 6.40388 2.63109 +6674 4 37.7242 29.471 6.47402 -15.8477 4.38345 -15.5494 +6675 6 42.5297 15.7017 39.7864 -1.2311 2.72873 2.24862 +6676 4 42.7877 16.6334 39.6476 -7.55712 -4.9727 -7.52807 +6677 4 42.0746 15.3358 38.9963 17.4435 12.5166 7.69263 +6678 6 19.8571 7.43592 22.0545 -24.1472 -5.51637 33.4113 +6679 4 19.2244 8.12179 21.7601 9.35088 -5.78158 -2.10146 +6680 4 19.4596 7.11536 22.9248 14.2781 17.6372 -34.9907 +6681 6 27.4149 3.22069 12.5516 40.9266 14.4549 -35.8463 +6682 4 28.3021 3.29229 12.0821 -30.0356 5.19144 18.8294 +6683 4 27.3767 2.28812 12.7581 -5.67627 -4.82192 6.74426 +6684 6 34.4116 6.50186 34.3661 -21.9879 -4.07114 7.78674 +6685 4 33.6675 7.13398 34.4265 8.52018 -4.33452 -1.60522 +6686 4 34.0848 5.70903 34.842 8.55338 12.1797 -0.556276 +6687 6 9.89342 27.9558 39.7643 36.6491 -8.46867 13.0669 +6688 4 10.8456 28.0225 40.104 -41.9626 -4.51635 -15.7261 +6689 4 9.67004 28.8098 39.3873 2.34979 10.3628 -2.65954 +6690 6 50.5619 22.115 6.39208 17.1303 26.4748 31.0688 +6691 4 51.4904 22.4109 6.45725 -8.74694 -11.3909 -7.00891 +6692 4 50.1939 22.6078 7.15954 -8.62199 -11.7106 -16.757 +6693 6 47.1151 11.4881 30.0373 19.0993 -20.4412 31.5796 +6694 4 47.2481 10.8506 30.7795 8.25865 21.4973 -13.9376 +6695 4 46.3269 11.1564 29.6474 -26.9131 -5.13028 -17.9745 +6696 6 25.9416 28.4741 9.79918 -11.6773 -32.55 32.2578 +6697 4 26.8348 28.2861 10.1548 -13.4597 2.20587 -7.83095 +6698 4 25.3328 27.8368 10.2912 20.3964 27.2145 -12.4741 +6699 6 35.4384 36.5941 19.4416 12.9267 19.1414 22.694 +6700 4 35.4164 36.6623 20.432 -0.885856 -8.21646 -20.3497 +6701 4 36.1159 37.2681 19.2232 -9.51806 -6.29836 -4.59986 +6702 6 39.0948 17.8654 12.2958 16.402 12.2899 -6.89152 +6703 4 39.0474 18.8007 12.5965 -2.38328 -10.6878 -1.40665 +6704 4 38.4419 17.3626 12.7715 -16.1853 0.319976 14.0097 +6705 6 2.67108 27.1436 2.40101 -1.75759 -3.65761 -8.1759 +6706 4 1.9876 27.5644 1.84788 8.2175 -2.76418 4.2561 +6707 4 2.53155 27.392 3.3289 1.87867 -1.67129 -3.85288 +6708 6 12.3359 32.2055 21.5153 -21.7508 0.12991 31.168 +6709 4 12.6488 32.0797 22.4173 29.0853 13.2861 -13.6486 +6710 4 11.491 31.8094 21.7155 -17.148 -0.720271 -25.2422 +6711 6 32.8833 32.3716 8.45599 -19.6455 -21.472 -14.5807 +6712 4 33.4538 32.8256 9.05859 9.48117 21.6574 11.6239 +6713 4 31.9723 32.7028 8.50155 9.17651 3.82723 3.41156 +6714 6 12.6485 6.44458 31.9777 -6.29944 1.49663 15.4125 +6715 4 13.1578 6.35833 31.1835 12.9638 -3.65534 -14.9347 +6716 4 11.7474 6.25334 31.7296 -4.07419 -1.29291 -2.47195 +6717 6 41.3645 27.7433 14.0415 -6.01814 -18.8263 -25.007 +6718 4 41.8124 27.3175 13.2596 -11.5333 15.588 22.1217 +6719 4 40.3975 27.5756 13.9407 20.5065 3.01622 5.4742 +6720 6 6.60161 16.499 25.4489 9.93734 -1.87947 -15.8553 +6721 4 7.35848 15.8951 25.4583 3.3895 5.33583 -1.00098 +6722 4 6.02379 16.0419 24.8253 -6.53341 1.34025 8.2366 +6723 6 21.7786 39.2974 13.3607 -58.7317 27.2846 42.4257 +6724 4 22.3848 39.3902 12.6828 41.4687 -6.70168 -50.5194 +6725 4 21.6228 40.2371 13.624 5.27297 -27.3266 2.34771 +6726 6 34.8408 6.01319 6.94562 -18.4641 -1.51643 5.78804 +6727 4 33.8445 5.90926 6.91888 31.3517 2.57767 -4.40922 +6728 4 35.1545 6.28252 6.0657 -8.54142 -2.93715 0.97402 +6729 6 33.0232 30.4151 33.1713 -30.7469 -3.39927 -39.9685 +6730 4 32.1382 30.6983 32.7963 25.7009 -18.3352 9.36685 +6731 4 33.1108 30.988 33.8978 7.7837 23.494 30.6115 +6732 6 15.4491 32.4129 12.2013 37.3068 -21.1945 16.3611 +6733 4 16.3823 32.073 12.2446 -28.3662 8.39135 1.47263 +6734 4 15.4224 32.8258 11.3561 0.313824 15.5191 -23.5701 +6735 6 12.6648 26.6033 21.3782 33.3074 -46.6123 -64.9668 +6736 4 12.0344 25.8976 21.5501 -12.6652 14.4466 17.403 +6737 4 12.7392 27.3327 21.935 -15.9008 39.2731 46.5109 +6738 6 47.0171 36.3051 29.9756 -14.9097 -3.99946 59.7783 +6739 4 47.3887 37.0247 30.5306 -0.120183 -5.44251 -19.0377 +6740 4 46.4147 35.8463 30.6463 22.302 11.6315 -30.1098 +6741 6 0.299553 12.7005 23.3858 -50.0817 10.3486 20.6993 +6742 4 0.55843 11.8154 23.133 6.9712 -0.709946 -9.28769 +6743 4 54.2783 12.6185 23.429 39.7411 7.62342 -2.706 +6744 6 54.1651 18.9185 21.5773 -27.3575 7.2555 -32.8787 +6745 4 0.055729 18.801 21.8215 42.2187 -10.4087 33.76 +6746 4 54.2632 18.7361 20.6344 -21.3012 2.13243 0.141772 +6747 6 25.7162 24.2884 23.7449 23.2111 -33.139 -2.25213 +6748 4 25.1836 23.5617 23.2944 18.61 24.747 21.927 +6749 4 26.5708 23.8587 24.0884 -36.4232 14.4676 -16.0896 +6750 6 11.8952 29.0236 26.8796 9.31073 -5.31833 9.58593 +6751 4 12.582 29.6684 27.1204 -3.01706 -1.21814 -5.31042 +6752 4 12.0145 28.319 27.5465 -5.16863 11.8863 -12.5997 +6753 6 48.0052 35.8598 10.6996 -18.0426 -22.591 -32.4945 +6754 4 48.7896 35.6794 10.1443 -7.64403 10.0758 9.7343 +6755 4 48.2747 36.3464 11.4544 19.4818 11.8303 20.3364 +6756 6 47.6544 29.8545 36.9555 47.7155 -39.8456 -42.9298 +6757 4 48.1196 29.373 36.1789 -16.9409 17.9192 43.9777 +6758 4 46.9556 30.2951 36.4995 -17.6283 12.0501 3.0439 +6759 6 7.32865 12.3513 10.6225 -20.3459 13.1064 -14.334 +6760 4 7.20572 12.8267 9.76478 7.03806 -14.4953 16.449 +6761 4 6.49136 12.5857 11.0944 24.1086 -12.0498 -8.15528 +6762 6 52.9256 15.9641 4.89737 -18.3283 -2.7411 -11.4996 +6763 4 53.001 16.1105 3.94443 2.36662 -0.713792 8.85774 +6764 4 53.8018 16.0105 5.25645 21.1817 2.44507 8.14275 +6765 6 10.6731 16.9472 34.6118 -36.7423 -4.99845 -47.4494 +6766 4 11.0533 16.8484 35.4724 -5.12202 -12.2675 26.0308 +6767 4 9.83371 16.4151 34.3796 40.245 18.7583 25.5995 +6768 6 25.147 31.0596 36.0152 -5.60145 -19.7687 -32.0201 +6769 4 25.7935 31.7656 36.1171 1.22463 2.78419 -3.72446 +6770 4 25.3418 30.5949 35.1615 -4.38154 15.6016 24.1358 +6771 6 34.0913 21.8858 41.4775 -4.76405 18.1665 32.5634 +6772 4 33.6625 21.1007 41.1787 -2.29922 -28.5955 -6.85504 +6773 4 34.6054 22.1733 40.7506 14.2114 10.2598 -30.2937 +6774 6 15.7731 30.0818 1.26798 39.0641 -13.3599 -49.0464 +6775 4 15.0823 30.4241 1.791 -23.818 19.5269 30.6537 +6776 4 16.2108 30.862 0.84325 -15.3415 -19.24 18.755 +6777 6 29.5302 27.8609 16.6022 -41.3972 -29.0796 28.0786 +6778 4 29.3307 26.8764 16.753 17.6765 42.2449 -1.67193 +6779 4 28.8227 28.3009 17.156 20.6394 -5.21731 -15.3441 +6780 6 39.6438 9.77612 0.552706 9.07327 13.2864 29.0584 +6781 4 40.129 10.5839 0.897097 -15.1313 -20.9808 -12.8857 +6782 4 39.4906 9.23066 1.36029 2.34479 9.54176 -15.0004 +6783 6 1.51524 31.8825 16.4089 -15.0842 0.567558 32.708 +6784 4 2.11225 32.2249 15.7721 17.5465 17.6302 -23.3114 +6785 4 1.56386 30.9485 16.2687 -0.663138 -25.5376 -6.36093 +6786 6 8.73078 39.8635 25.0545 2.96185 -34.7465 -17.9129 +6787 4 8.00321 39.5602 25.6169 4.07363 9.59654 5.53067 +6788 4 8.89391 40.7829 25.2096 -1.06312 24.7623 5.36493 +6789 6 42.3301 10.2778 9.76455 0.0249942 22.0437 -8.66619 +6790 4 42.035 10.1947 10.6715 6.68889 -4.55788 7.04955 +6791 4 42.6957 11.1854 9.68656 -1.85544 -15.7885 0.75259 +6792 6 13.241 7.61416 1.95847 -11.6175 -6.73398 30.6404 +6793 4 13.9892 7.82191 2.54806 -1.36929 5.6022 -7.80568 +6794 4 12.5695 7.22502 2.56499 11.7798 7.16895 -16.7116 +6795 6 18.7434 40.0583 14.2212 10.8937 -7.32712 21.4541 +6796 4 19.2417 39.7541 15.0131 -1.99408 15.6159 -18.1773 +6797 4 17.935 39.549 14.2832 -4.44855 -3.57314 -3.37042 +6798 6 20.0977 14.0454 38.5561 35.4799 -67.417 -7.49733 +6799 4 20.2641 13.632 37.67 -9.31749 10.6865 24.2255 +6800 4 19.7827 14.877 38.3297 -23.7972 64.5272 -8.60678 +6801 6 22.6565 28.8842 34.0588 -5.52315 8.37947 20.7951 +6802 4 23.0585 28.228 33.4828 2.77778 -4.34029 0.307399 +6803 4 22.9395 28.703 34.9822 0.354749 -6.57221 -14.6515 +6804 6 22.6874 4.70198 5.2328 -25.042 -9.90055 15.5414 +6805 4 22.1274 3.9708 5.56882 12.1557 -0.0327816 -16.8284 +6806 4 22.5434 5.31639 5.94822 12.9551 16.3877 4.62095 +6807 6 23.6492 33.9942 38.3998 23.375 33.8394 -43.1733 +6808 4 22.8011 33.6715 38.57 -44.227 -25.7371 21.164 +6809 4 23.4749 34.4069 37.5183 19.103 -7.547 16.6445 +6810 6 48.374 21.3549 17.2744 -0.727013 41.2048 -23.9838 +6811 4 48.2041 22.3166 17.0448 3.0192 -25.1475 26.0409 +6812 4 48.3509 20.9743 16.3868 -2.31832 -8.94154 10.8829 +6813 6 11.5758 10.9938 8.63273 -18.0621 42.8191 15.9647 +6814 4 11.6313 10.2483 9.25156 -2.19238 1.01339 1.87179 +6815 4 11.0547 11.7764 9.03291 21.9333 -36.8133 -6.7089 +6816 6 40.0924 28.1686 33.4857 17.1635 -5.37387 30.2378 +6817 4 41.046 28.3881 33.5354 -13.2006 -3.32107 -11.2861 +6818 4 39.7443 28.4933 32.6629 4.51627 6.28126 -11.3213 +6819 6 47.3837 25.6703 5.29617 28.7657 21.9065 -4.48206 +6820 4 46.461 25.5322 5.12569 -20.8862 2.51482 -4.893 +6821 4 47.6179 26.6114 5.08959 -12.3293 -15.1007 -0.275896 +6822 6 21.6517 35.2222 23.996 27.7917 10.3485 -3.89698 +6823 4 21.6311 34.5383 24.6593 -10.5502 -12.8786 6.64496 +6824 4 22.5954 35.4881 23.9966 -15.7417 2.23004 -2.6139 +6825 6 8.24409 41.4919 8.41354 9.22969 12.4334 -12.8549 +6826 4 8.15 40.8674 7.67873 -1.07657 -2.81584 5.48771 +6827 4 7.83543 41.113 9.18983 -1.52095 -3.2343 5.88405 +6828 6 16.4798 31.1082 22.2131 -4.24513 -17.8742 -2.35359 +6829 4 17.0752 30.8161 21.5077 -7.18137 4.28218 -7.0656 +6830 4 17.0564 31.1902 22.9696 5.97679 -0.907857 10.4567 +6831 6 54.7122 0.459271 28.3177 -16.7834 -37.5181 -6.57119 +6832 4 0.641958 0.15455 28.3975 4.09167 16.1916 -1.73275 +6833 4 54.5379 1.34634 28.6236 20.797 14.6923 4.72985 +6834 6 48.4477 15.3762 4.17752 -7.35125 -30.0531 -4.44848 +6835 4 49.1738 15.1128 4.81019 -14.8803 0.337287 -24.8229 +6836 4 48.0902 14.5922 3.6288 23.2827 31.0113 24.8784 +6837 6 34.3541 7.00171 40.4295 26.6588 -46.9533 -23.8625 +6838 4 33.6168 6.99428 39.8319 -14.4938 10.2897 -3.98371 +6839 4 34.9839 6.35967 39.9588 -19.3291 28.4488 24.7248 +6840 6 41.3507 3.37676 17.0028 -19.6969 -26.4955 -6.96819 +6841 4 41.02 2.66518 17.5936 5.53648 12.9859 -1.78552 +6842 4 41.944 3.90566 17.5305 10.5068 9.85924 8.73726 +6843 6 48.4427 20.685 14.5419 46.8112 -36.6841 26.4704 +6844 4 48.0177 21.3487 14.0717 -32.7597 47.8552 -32.6818 +6845 4 49.3877 20.9188 14.5227 -9.08294 -4.43462 -1.64124 +6846 6 52.4922 28.1277 37.1182 6.87418 8.84651 -10.3419 +6847 4 53.4134 28.4024 37.0408 3.12987 -6.6922 4.15316 +6848 4 52.2752 27.8963 36.2007 -7.47166 7.06161 9.73328 +6849 6 53.8774 18.5638 18.79 -18.2161 -77.5341 7.0005 +6850 4 54.7018 18.1425 18.5274 3.76082 -0.315502 -3.76089 +6851 4 54.0435 19.4528 18.7445 16.4561 77.5259 -2.54699 +6852 6 41.0011 39.1407 28.7879 -31.3786 -4.09579 71.7092 +6853 4 41.3911 39.2094 27.9661 28.9736 8.71878 -68.6315 +6854 4 40.0521 39.3021 28.7019 -2.27612 -3.41331 -6.23213 +6855 6 38.2743 8.75074 24.2285 24.5029 -7.68366 -19.8132 +6856 4 39.1919 8.60362 23.8621 -28.3827 4.68959 18.7737 +6857 4 38.3545 9.42009 24.9092 0.456349 2.35846 11.2764 +6858 6 2.99111 29.1615 9.6319 43.2691 -54.6401 14.341 +6859 4 2.5338 28.6319 8.99687 -12.0219 1.86489 -18.3516 +6860 4 2.58318 29.9865 9.638 -27.8835 49.5023 8.75508 +6861 6 27.5756 29.2755 18.3378 -4.01048 -11.7045 41.1881 +6862 4 26.7643 29.1652 17.8389 -11.7278 -2.11582 -9.62984 +6863 4 27.2839 29.0037 19.2864 20.9622 13.2114 -52.0932 +6864 6 11.8501 21.1733 10.1172 4.58733 -51.566 26.4002 +6865 4 12.2099 22.0246 9.9906 13.4732 33.828 -10.0235 +6866 4 12.4495 20.7458 10.776 -15.5727 16.0367 -15.8372 +6867 6 16.9004 32.2989 0.299881 0.133752 -22.2186 -6.7835 +6868 4 17.7029 32.7095 0.626455 9.4749 11.3588 3.4417 +6869 4 16.2118 32.9605 0.285394 -3.66285 20.1796 -4.1714 +6870 6 1.30064 17.4766 22.5523 32.9941 -5.4384 -19.965 +6871 4 1.2446 16.5356 22.2294 -6.1018 21.6977 3.5382 +6872 4 2.22906 17.8023 22.3815 -23.7878 -13.737 8.2324 +6873 6 41.5474 6.85538 29.3077 15.2611 30.5857 3.861 +6874 4 41.7413 5.96016 29.5642 -1.91107 -14.5726 0.121693 +6875 4 42.0251 7.37916 29.9826 -12.8279 -1.76094 -5.06557 +6876 6 10.5087 10.782 13.8577 27.0965 -13.6956 13.3978 +6877 4 10.7007 11.2274 13.0253 -2.16043 3.73872 -7.98734 +6878 4 11.2742 10.169 14.0479 -24.5023 11.0776 -3.5626 +6879 6 39.8289 15.4978 40.8346 25.2099 1.13818 0.661387 +6880 4 40.0487 16.0673 40.0758 -9.90377 -2.84048 2.34508 +6881 4 40.6829 15.4254 41.3222 -18.4618 6.82556 -4.74882 +6882 6 26.5164 19.6052 40.5088 -9.33805 1.61856 -11.7217 +6883 4 27.41 19.9717 40.4897 0.274496 -7.70925 5.49567 +6884 4 26.4209 18.9712 41.2422 6.64723 7.57269 5.06511 +6885 6 54.036 8.18782 13.7715 27.5212 34.9045 -2.54262 +6886 4 54.5316 7.46918 14.1378 9.61628 -19.3806 0.327355 +6887 4 53.1925 7.88218 13.5309 -39.9219 -15.1658 -7.5943 +6888 6 15.6949 25.3434 10.6718 -31.7842 -7.37099 0.0612328 +6889 4 15.1805 25.3333 9.84403 14.6699 1.30202 -4.92807 +6890 4 14.9666 25.3615 11.3188 15.8696 -4.15214 -3.47235 +6891 6 18.5987 3.44175 21.9294 71.7321 -9.69418 15.9409 +6892 4 19.6071 3.44542 22.1959 -64.1569 1.8736 -14.3483 +6893 4 18.6296 3.58776 20.9721 -7.77871 5.49431 4.81248 +6894 6 50.8883 20.6265 18.5187 28.1172 41.6529 17.9746 +6895 4 50.1573 21.1733 18.1958 -9.23125 -9.06144 -4.34911 +6896 4 51.4834 21.2842 19.0045 -23.468 -29.5191 -15.1667 +6897 6 53.3673 20.9038 31.2869 -12.1652 -1.18869 -3.23134 +6898 4 53.2409 20.9073 32.2442 5.88471 -1.70994 -0.407299 +6899 4 52.4717 20.8062 30.9053 11.2743 1.61965 3.90294 +6900 6 52.8102 27.6189 28.9831 -34.4743 -7.30027 30.0453 +6901 4 52.2848 27.4362 29.7987 1.4862 0.901255 -27.4551 +6902 4 53.4947 28.1361 29.3473 35.4934 25.3811 1.80223 +6903 6 33.3112 15.6955 11.3264 12.7704 9.00306 37.7013 +6904 4 33.4999 16.1238 12.2198 -3.00415 -23.4283 -28.8796 +6905 4 32.4346 16.0003 11.1059 -7.33456 8.94646 -4.12361 +6906 6 20.3875 26.8057 27.4813 21.213 -4.31231 15.2493 +6907 4 19.6396 27.3594 27.2578 -2.8557 9.66202 -0.370116 +6908 4 20.9667 27.2946 28.1279 -24.4059 -13.8952 -19.2793 +6909 6 8.54399 2.06163 14.1713 4.36483 17.1543 -0.299448 +6910 4 8.13837 1.20516 14.196 -9.47708 -17.773 2.17407 +6911 4 8.01805 2.60085 14.7902 6.78451 -6.83093 -3.12033 +6912 6 40.1002 7.56575 40.6778 12.4019 9.60944 38.6013 +6913 4 39.712 8.14959 41.3779 4.03526 -4.70584 -30.6789 +6914 4 40.8329 7.16354 41.1893 -8.78874 -6.51591 -16.4763 +6915 6 6.89044 6.83556 10.7869 16.1514 15.8461 -3.23426 +6916 4 7.31622 7.70217 10.5979 -16.164 -15.6489 3.8938 +6917 4 7.04178 6.69918 11.735 -3.2221 -0.411834 -4.21297 +6918 6 31.2643 6.58983 20.136 22.5576 -57.6677 6.94967 +6919 4 30.6637 5.92034 20.5005 -2.47046 2.78164 8.35653 +6920 4 30.7152 7.30056 19.9711 -35.0351 52.1138 -11.6241 +6921 6 54.5411 21.0454 27.2925 4.1013 -43.0328 84.8338 +6922 4 0.071192 20.2129 27.5399 -15.6737 30.1382 -21.2093 +6923 4 54.6532 21.3072 26.4181 12.1035 8.54749 -60.3726 +6924 6 4.75213 23.1508 16.2245 -49.4139 4.34438 -28.0546 +6925 4 4.2471 24.0009 16.1592 20.3634 -17.2761 5.59937 +6926 4 5.4972 23.3136 16.7675 27.2932 5.42097 22.4316 +6927 6 25.5515 11.0241 14.8358 9.2665 0.546345 5.2197 +6928 4 26.0976 10.3608 15.3182 -9.73323 12.0118 -14.516 +6929 4 25.8683 11.8947 15.1133 0.0398252 -5.90721 -2.6003 +6930 6 41.1974 41.7784 29.942 -27.7855 -7.97533 -10.6302 +6931 4 40.9203 40.8727 29.6366 8.3922 29.767 6.72032 +6932 4 40.4023 0.465719 29.8931 18.9924 -15.525 2.17149 +6933 6 52.2793 15.2936 41.6313 19.4314 -9.06844 -20.2837 +6934 4 51.991 15.9601 0.331443 -10.9307 10.9541 10.4228 +6935 4 51.6032 14.6231 41.5544 -13.8311 -6.7739 0.824233 +6936 6 37.7418 21.7882 37.8505 9.73059 24.2058 3.49681 +6937 4 37.8176 20.8655 37.6583 6.26781 -24.8638 0.142384 +6938 4 38.1128 21.8753 38.7352 0.661952 0.248137 2.40564 +6939 6 23.8436 9.73697 27.5598 -17.3101 -56.824 -21.1542 +6940 4 23.6823 8.97924 26.8635 13.0753 42.6322 38.797 +6941 4 23.3674 9.48178 28.3892 6.27388 8.11738 -19.7561 +6942 6 43.0121 28.0431 32.8137 29.5034 -18.022 1.83467 +6943 4 42.9555 27.148 33.1715 -16.7807 6.42622 4.12236 +6944 4 43.9561 28.0675 32.5908 -15.6612 14.0802 -2.62256 +6945 6 34.1451 21.2362 11.9042 -10.4207 -39.0944 -3.26361 +6946 4 33.7785 20.3444 12.1585 8.75301 27.3815 0.918114 +6947 4 33.7383 21.3833 11.0382 -2.92284 10.3561 2.31655 +6948 6 10.5016 31.8267 10.0873 5.91889 6.7472 5.74276 +6949 4 10.9186 32.6594 10.3946 -11.2895 -14.4825 -9.55855 +6950 4 9.99233 32.0033 9.274 9.03923 7.50024 8.93884 +6951 6 35.8744 37.1309 22.1208 9.07655 -0.20125 -37.6945 +6952 4 36.7757 37.5102 21.9868 -16.2539 -8.14962 7.83623 +6953 4 35.5893 37.243 23.0078 -0.963312 7.56509 34.0991 +6954 6 27.293 4.59192 27.4599 -62.9251 -2.97268 8.43797 +6955 4 27.8573 4.63875 28.2367 1.75868 -0.322614 6.7695 +6956 4 26.3027 4.46726 27.7774 60.9698 2.85981 -12.9146 +6957 6 39.0165 22.2861 10.6525 -25.2911 9.99335 20.5692 +6958 4 39.5938 21.9801 9.97437 16.8498 -5.94336 -19.6369 +6959 4 38.1468 22.3658 10.2352 2.38909 -7.32087 0.337973 +6960 6 30.765 39.1813 10.9358 -26.8864 17.0789 0.421318 +6961 4 31.7273 39.1993 11.0368 0.254075 -10.0442 -6.8497 +6962 4 30.3957 38.288 10.8473 24.5485 -0.522695 0.476538 +6963 6 44.5972 26.9475 2.20695 17.6159 -27.9211 -0.145864 +6964 4 44.8477 26.0903 2.61727 -13.9349 20.2639 -7.87324 +6965 4 45.3006 27.0404 1.55025 0.322606 15.9 1.66232 +6966 6 23.7817 14.549 26.4845 -13.1218 37.1912 -28.6876 +6967 4 23.5085 15.1786 25.7375 18.3344 -26.327 26.4977 +6968 4 23.2314 13.7794 26.3439 -3.10125 -8.02717 6.138 +6969 6 38.3349 13.3785 39.6531 51.0719 11.8768 18.627 +6970 4 39.1134 13.8424 40.1004 -28.3003 -20.0613 -21.9332 +6971 4 37.637 14.0102 39.7945 -20.9869 -1.09015 1.55638 +6972 6 17.9076 17.2343 29.3998 2.5182 -11.8623 9.07057 +6973 4 17.7005 16.8028 28.5679 -0.208052 -3.06359 -6.42367 +6974 4 17.2973 17.9612 29.4206 -13.3644 14.2602 6.84169 +6975 6 17.427 29.8312 9.9167 5.70667 9.14636 11.5297 +6976 4 16.5259 29.8398 9.63655 -18.5043 -5.93208 -2.5299 +6977 4 17.9097 29.6705 9.11934 16.3543 -3.78316 -10.6623 +6978 6 35.6302 6.05705 19.6249 -12.632 -1.17761 -30.1407 +6979 4 35.1756 5.57436 18.904 4.12491 -0.359791 14.6292 +6980 4 35.7342 6.9119 19.1826 9.40393 1.91765 12.7562 +6981 6 18.674 22.2857 17.523 8.42296 3.39096 21.1197 +6982 4 17.7402 22.4481 17.6821 -9.17854 0.615652 -6.61815 +6983 4 18.8674 22.3747 16.5992 -7.41694 3.44878 -20.9034 +6984 6 20.0258 3.81405 32.2871 -5.45876 10.2161 0.982716 +6985 4 19.684 4.03807 31.424 -2.67861 3.00481 -7.64614 +6986 4 20.9375 3.54321 32.099 -1.59169 -5.33194 9.42598 +6987 6 5.47094 6.98417 8.10987 -1.95658 -27.204 5.03178 +6988 4 5.85072 7.84658 8.088 3.96324 28.039 -6.11929 +6989 4 5.94584 6.55919 8.82772 -3.50663 -6.33739 10.9422 +6990 6 44.182 20.5312 25.5979 43.1361 -13.705 -19.148 +6991 4 44.6875 21.1042 26.1493 -15.9255 27.6084 29.7698 +6992 4 44.9726 20.2272 25.1253 -26.0739 -14.4287 -20.9555 +6993 6 43.9621 36.9892 17.8709 27.7049 17.1418 -9.42399 +6994 4 44.6647 37.4643 17.3692 -13.724 -4.61297 12.4448 +6995 4 43.6121 36.3808 17.225 -14.1002 -14.0328 0.985329 +6996 6 34.6183 10.1148 16.2555 -4.96303 14.2933 -37.1542 +6997 4 34.4099 10.1014 15.264 7.63186 -7.52385 38.4141 +6998 4 34.6455 11.0716 16.4378 1.03434 -4.81203 3.48645 +6999 6 23.6535 3.43617 1.32551 9.32991 -27.0385 -60.023 +7000 4 23.5361 2.47498 1.09872 1.70789 26.2755 24.74 +7001 4 23.8607 3.79652 0.414552 -11.3127 6.44054 37.9529 +7002 6 33.4225 38.9606 5.09116 -45.0556 15.9463 14.7537 +7003 4 32.9187 38.171 4.91655 10.2233 -24.4058 -4.43744 +7004 4 32.6531 39.5198 5.39063 34.9247 3.3662 -8.43025 +7005 6 22.5542 32.508 35.8091 -1.62577 21.6885 -22.4452 +7006 4 23.4313 32.1432 35.8321 13.5304 -8.64793 9.08541 +7007 4 22.6972 33.4304 35.4917 -7.91418 -12.6316 15.6694 +7008 6 32.4209 37.2696 13.8263 22.6153 37.4816 -15.7005 +7009 4 31.6314 36.8608 13.5507 -35.0264 -17.3769 -13.0658 +7010 4 32.7321 36.7183 14.5153 12.3601 -27.6025 17.2047 +7011 6 52.6048 12.7515 39.5965 -13.8302 -6.28036 -1.32475 +7012 4 53.26 13.3571 39.2655 9.70847 9.80763 -6.22213 +7013 4 53.0114 12.2827 40.3245 7.10516 -3.61819 3.538 +7014 6 28.8284 14.5654 1.23244 38.3097 18.383 -14.9432 +7015 4 28.2834 13.8143 1.34735 -23.3809 -22.0338 3.15251 +7016 4 28.3672 15.33 1.56727 -9.74512 0.414323 3.22557 +7017 6 1.45359 32.4205 23.3989 -1.05001 -40.1011 -18.1189 +7018 4 1.47013 31.5606 22.9188 -1.41837 10.7967 19.8874 +7019 4 1.97354 32.9442 22.8182 11.5552 29.203 -12.5869 +7020 6 54.3296 23.3325 28.9716 1.50467 4.34178 0.834044 +7021 4 54.2574 22.8567 29.7964 -0.193368 0.82753 11.1745 +7022 4 54.4723 22.6371 28.331 0.325397 -5.40149 -8.07104 +7023 6 14.3127 12.1509 35.6633 -33.5663 -10.8168 -13.6472 +7024 4 14.2878 12.7047 36.4184 6.74358 21.3133 20.6565 +7025 4 15.1756 11.8015 35.6107 35.8459 -8.25269 -4.05635 +7026 6 18.9986 6.53226 41.2771 -21.1361 -24.8418 -24.3627 +7027 4 18.366 5.78703 41.1105 9.63211 18.6573 18.8829 +7028 4 19.3119 6.48514 0.272589 3.11598 2.01554 11.5533 +7029 6 5.32991 17.8836 20.3428 -30.4167 16.0599 6.69424 +7030 4 4.7967 18.411 19.709 2.93149 -9.05217 4.33299 +7031 4 4.77097 17.8526 21.1546 15.0176 4.61027 -13.5236 +7032 6 24.7236 34.9657 30.1688 -3.59195 -26.0802 -14.261 +7033 4 24.7803 35.9013 30.0428 5.00342 21.1487 3.94382 +7034 4 24.6904 34.5809 29.2706 1.13339 13.2018 12.9935 +7035 6 31.868 4.6188 18.1813 26.0749 -11.7783 -2.21043 +7036 4 31.7807 5.26575 18.8694 -2.85928 14.415 8.06415 +7037 4 31.0011 4.54965 17.8036 -17.7428 -0.954819 -5.29079 +7038 6 8.70915 17.4782 5.92977 -5.10088 36.478 0.166614 +7039 4 7.99285 18.1665 5.8727 10.0003 -20.7449 -0.10219 +7040 4 9.53277 18.014 5.87919 -8.17468 -12.6369 7.06335 +7041 6 29.8448 10.9674 14.467 -9.24737 10.8237 6.24964 +7042 4 29.3518 11.4625 13.8111 -3.5417 -3.22768 -11.9456 +7043 4 29.8741 11.602 15.1948 7.6561 -6.41884 12.5924 +7044 6 48.7193 10.2987 32.5837 48.7914 -16.5053 -5.27468 +7045 4 48.664 9.84191 33.449 -1.5926 15.0761 -9.20872 +7046 4 49.6917 10.1556 32.2801 -49.2626 10.4163 8.33251 +7047 6 8.33128 15.6672 37.865 4.36755 4.12409 -33.9682 +7048 4 8.08142 16.0688 38.661 -6.22033 14.9054 48.1983 +7049 4 7.78443 16.1766 37.2488 7.82296 -4.92397 -7.06368 +7050 6 50.3849 3.07587 17.3306 53.0616 0.797084 -5.54454 +7051 4 49.9901 2.96071 16.4818 -23.7547 4.5323 -14.3202 +7052 4 49.831 3.21284 18.0832 -29.2444 4.71684 15.357 +7053 6 14.687 38.3962 10.9034 11.8452 2.26847 -28.7684 +7054 4 14.4993 38.5723 11.8231 -13.1425 0.700252 11.382 +7055 4 14.2628 37.5785 10.602 -2.45756 1.24341 13.1034 +7056 6 34.1174 6.37976 10.8168 12.9161 5.50138 13.5595 +7057 4 34.1292 7.23477 10.3416 2.23773 -14.4836 1.59416 +7058 4 34.9287 6.34152 11.3848 -14.7297 9.70771 -12.8953 +7059 6 7.1619 37.5492 17.6341 50.2032 -5.81562 0.15107 +7060 4 8.17599 37.5098 17.465 -47.7372 -0.307972 7.49553 +7061 4 7.05745 37.0565 18.4805 -8.53445 9.44148 -12.9936 +7062 6 51.515 11.3168 16.7982 -26.0757 5.86397 -27.0874 +7063 4 52.235 10.8459 17.1551 30.0977 -19.3818 20.7126 +7064 4 51.5008 11.0547 15.8562 -2.22905 10.0255 8.80825 +7065 6 15.6633 8.64974 3.19872 2.04011 -21.0584 -36.8111 +7066 4 15.359 9.2987 3.81038 -7.3063 19.0886 25.5551 +7067 4 16.1924 8.00887 3.67257 5.32849 -2.14206 7.59436 +7068 6 5.43671 21.4488 11.9213 -35.1135 30.2715 2.68526 +7069 4 5.1197 22.3031 11.5306 26.1226 -15.3225 -1.30607 +7070 4 4.71321 21.2794 12.5494 12.8867 -7.97314 3.40019 +7071 6 50.1888 24.041 37.9733 -16.5158 11.6838 -8.72192 +7072 4 49.5513 24.2503 37.2525 13.6843 -9.6942 16.9361 +7073 4 50.7608 23.3204 37.7156 0.52347 -2.66969 -5.08066 +7074 6 39.7366 11.2383 31.6978 23.7892 31.0409 -10.9794 +7075 4 40.3477 11.919 31.322 -8.85632 -23.7146 9.45819 +7076 4 38.8907 11.643 31.516 -11.7678 -2.00245 1.00495 +7077 6 26.6862 10.831 20.5846 -4.64528 13.8134 22.6501 +7078 4 26.37 11.3609 21.3584 5.46785 -6.26709 -23.7021 +7079 4 26.5097 9.94471 20.9062 3.28762 -9.42115 -6.7075 +7080 6 12.5617 17.5693 18.1619 57.3415 -16.6047 -35.4946 +7081 4 12.3732 16.6356 17.927 -10.1847 12.7431 11.2408 +7082 4 11.9536 17.9401 18.7496 -47.3477 6.23269 31.2745 +7083 6 47.7779 31.603 17.3345 -16.0229 -2.6295 -18.0517 +7084 4 48.4774 31.3981 17.9449 0.342859 -12.7175 10.4199 +7085 4 47.3751 30.7658 17.0144 6.51745 15.1025 2.87388 +7086 6 1.06661 3.38166 18.5387 0.482315 1.39351 -20.5486 +7087 4 1.47214 3.81044 19.3024 -7.19452 2.23946 8.83247 +7088 4 0.121217 3.21323 18.6865 2.92702 6.89788 10.7589 +7089 6 26.5916 20.3882 15.3141 4.05487 -19.1164 -7.10575 +7090 4 27.0276 19.5492 15.0037 -7.93965 16.9744 10.3813 +7091 4 25.6772 20.1067 15.4922 9.40368 -0.641397 -3.80974 +7092 6 42.0092 3.03717 36.7607 9.58516 7.42569 -27.539 +7093 4 41.472 2.27114 36.5289 -4.68032 -10.5632 12.6255 +7094 4 41.9749 3.27199 37.6769 -10.2045 -8.66607 25.0137 +7095 6 39.3197 22.4482 33.2161 17.1359 -6.1719 -1.11969 +7096 4 39.6777 22.5385 34.1471 -14.6651 4.73191 -34.7467 +7097 4 39.2891 23.3308 32.7977 1.66572 -7.01471 12.3298 +7098 6 18.4983 34.959 11.9233 -52.4092 11.8234 -6.15541 +7099 4 19.3311 34.9297 12.2931 62.358 -5.27325 28.8625 +7100 4 17.9525 35.2018 12.6795 -15.7268 -2.39727 1.11957 +7101 6 22.849 14.1156 0.206953 9.43339 -22.8796 20.8561 +7102 4 23.1273 14.7687 41.4941 9.338 18.1693 -9.76493 +7103 4 23.4344 14.2183 0.991573 -8.36464 7.13735 -11.7533 +7104 6 31.0127 16.6435 33.7717 -75.3989 -12.3916 10.6429 +7105 4 30.4261 16.8588 33.0132 20.7291 0.745933 12.1228 +7106 4 31.8948 16.7604 33.5238 39.9201 13.7608 -15.1754 +7107 6 28.4056 35.5121 5.54765 -4.91817 12.0412 -0.933493 +7108 4 29.0647 34.8486 5.74161 15.0982 -5.96625 -1.02933 +7109 4 28.8561 36.3656 5.44297 -1.6946 -6.58589 1.12865 +7110 6 2.06022 31.4415 10.6404 20.6415 1.38777 10.2498 +7111 4 2.4899 32.1989 10.2195 -2.44284 -2.19106 -3.22737 +7112 4 1.13111 31.6267 10.6164 -17.6565 -0.143118 -7.1498 +7113 6 5.95467 9.75858 21.3545 2.17354 8.87983 -50.8842 +7114 4 6.2643 10.5435 20.7894 -11.3634 -34.5597 22.4005 +7115 4 5.48441 9.14719 20.7121 9.8282 23.6666 23.1144 +7116 6 24.7866 26.6177 2.6661 -24.4024 -28.5469 2.9707 +7117 4 23.9476 26.6963 2.18158 9.10826 11.4817 -7.6186 +7118 4 24.6214 25.7954 3.1805 15.5163 19.2379 2.11057 +7119 6 45.7515 4.24664 18.6084 -0.948574 6.19926 2.59566 +7120 4 46.4738 4.91595 18.5123 -9.05862 -19.7882 -0.326833 +7121 4 46.0843 3.34349 18.421 4.31178 15.089 3.21664 +7122 6 4.45878 0.783326 15.9106 20.8465 2.39674 -2.22601 +7123 4 4.33336 41.7534 15.8294 -11.1347 -14.3847 -2.31303 +7124 4 5.37758 0.813141 16.2285 -10.0444 13.1447 -0.149196 +7125 6 2.44065 19.4988 25.3899 -18.2163 -19.9205 28.2208 +7126 4 1.89428 18.9873 26.0273 4.60516 17.0002 -8.33323 +7127 4 2.55045 18.8717 24.6878 9.48029 -1.77855 -17.0048 +7128 6 40.6027 8.48954 5.10826 -27.6355 -21.4881 -13.6167 +7129 4 40.6592 9.31425 5.57088 10.9479 16.5697 14.8472 +7130 4 41.3781 7.96424 5.30637 14.4251 2.68711 -2.52113 +7131 6 49.3092 22.3481 41.5186 -9.93734 74.0457 16.0776 +7132 4 48.4971 22.7919 41.1786 21.3857 -10.289 -0.267672 +7133 4 49.2285 21.4633 41.2985 -4.59952 -62.95 -16.8011 +7134 6 0.364483 40.9333 20.5966 -24.8933 -11.8265 -30.66 +7135 4 0.190818 39.9667 20.5681 4.35782 8.08342 1.06674 +7136 4 54.6936 41.3396 19.9676 13.1862 -7.22974 19.6204 +7137 6 34.8864 15.3279 38.0452 -17.1782 37.3505 -55.2903 +7138 4 34.2682 16.0872 37.9321 5.94042 -16.3876 6.60377 +7139 4 35.3697 15.4116 37.1797 -1.56134 -6.74346 24.1748 +7140 6 7.76223 25.9987 29.8652 25.7268 -8.51605 -4.95409 +7141 4 8.61839 26.4638 29.9588 -13.1921 -1.71741 1.7916 +7142 4 8.05672 25.0651 29.9772 -19.4202 16.3818 3.54783 +7143 6 40.7182 22.7954 20.4441 37.8127 13.8011 -33.8007 +7144 4 41.3586 23.4588 20.0133 -28.9149 -26.2189 23.8294 +7145 4 40.2017 23.2969 21.0583 -10.7099 15.3396 13.8501 +7146 6 37.6932 25.6399 36.0638 4.62997 10.0285 35.1853 +7147 4 38.3287 24.9236 36.1183 -2.20273 -4.01008 -9.65359 +7148 4 37.2914 25.6394 35.2107 -7.09628 -5.12362 -31.4654 +7149 6 5.46101 24.0014 10.2586 17.9799 16.5872 6.22131 +7150 4 6.04134 23.844 9.49543 -11.5162 -2.35388 5.85767 +7151 4 5.90746 24.7967 10.672 -23.415 -30.7572 -16.8601 +7152 6 48.4104 21.0451 38.1819 10.5351 27.9197 -28.7006 +7153 4 48.793 20.7803 39.017 13.2175 -6.38321 0.209366 +7154 4 49.1228 21.3802 37.5459 -28.8109 -18.4864 30.6779 +7155 6 15.2906 25.011 3.54101 2.70625 6.69817 -9.95824 +7156 4 15.4569 24.0555 3.50682 -9.52162 -0.514188 6.9158 +7157 4 14.6826 25.2483 4.2581 -1.83637 -10.9582 1.3864 +7158 6 46.3949 40.2718 20.0841 3.05266 -42.5213 0.389481 +7159 4 46.7282 39.319 20.1688 -17.5494 37.8624 -2.40649 +7160 4 47.138 40.8016 20.3323 14.2597 18.5668 -0.122304 +7161 6 34.6662 36.4732 0.324161 -52.0076 35.1593 -1.38074 +7162 4 34.82 35.9689 1.09464 17.4812 -18.6855 30.1307 +7163 4 33.7817 36.8781 0.601954 33.7085 -7.09846 -24.72 +7164 6 52.5968 8.00424 30.4116 -30.791 -5.83914 -1.44892 +7165 4 52.0396 8.66036 30.8559 12.8564 7.40177 -0.477247 +7166 4 51.9287 7.58179 29.8369 22.2614 -6.63703 0.63559 +7167 6 32.0772 3.86049 29.4688 -16.0025 -7.01815 -35.05 +7168 4 31.5382 3.03776 29.5615 20.8838 14.671 -1.22835 +7169 4 32.0904 4.03293 28.4798 -1.86833 -11.5506 40.3284 +7170 6 20.363 17.8245 28.646 3.47804 13.7512 -7.92665 +7171 4 19.5516 17.4966 29.0653 6.53113 9.74715 -6.36853 +7172 4 20.0825 18.3002 27.8308 0.555567 -8.90179 15.8758 +7173 6 30.4041 41.1634 41.0132 -16.7253 12.0993 -9.83452 +7174 4 30.5197 40.835 40.1072 4.71307 -5.7925 7.34595 +7175 4 31.1703 40.9637 41.5368 18.7313 -7.07732 1.06037 +7176 6 35.4542 32.8539 27.9215 21.6406 26.5455 -21.3275 +7177 4 35.1435 33.2362 28.7432 -6.21594 5.85967 7.97646 +7178 4 35.8745 33.6007 27.3754 -13.2283 -32.0923 16.9769 +7179 6 14.39 6.67952 12.731 -12.5058 36.491 0.424373 +7180 4 15.2321 6.28981 12.9462 8.74388 -6.1299 -2.75421 +7181 4 14.5067 7.66796 12.7988 -3.69921 -34.1177 -6.56265 +7182 6 41.8739 41.5433 20.319 24.4238 12.2951 6.29746 +7183 4 42.7192 41.2715 19.9184 -11.0628 6.38436 -6.30872 +7184 4 41.3184 40.7767 20.2955 -10.4459 -12.1473 -5.48062 +7185 6 46.3985 22.5739 8.8638 6.84921 19.3184 1.79378 +7186 4 45.8729 21.8991 8.42669 -3.07803 -12.5032 3.12866 +7187 4 47.1271 22.1566 9.33065 -8.50589 -8.34396 1.5145 +7188 6 17.4023 20.6526 13.9004 10.6995 28.5611 -11.4854 +7189 4 17.6978 21.6036 13.9579 -8.84666 -31.3302 7.07381 +7190 4 17.3123 20.5004 12.9448 0.490636 -3.23538 4.08121 +7191 6 8.20126 9.48382 13.3485 -42.4293 41.8522 17.2798 +7192 4 7.44487 10.0964 13.6076 19.5538 -29.8853 -13.4391 +7193 4 8.9576 10.0119 13.6277 13.7224 -9.45646 -1.54211 +7194 6 7.58554 14.8008 29.5824 -2.61798 9.90858 -2.64866 +7195 4 7.05733 14.3538 30.2458 -0.514214 1.68252 7.63674 +7196 4 7.01989 15.5029 29.2149 4.91731 -6.06465 -0.976267 +7197 6 29.5668 39.2268 22.6285 -3.66094 -2.39634 13.3419 +7198 4 29.8353 38.7557 23.4169 -4.20308 -7.76017 12.2752 +7199 4 30.3745 39.2765 22.1369 12.5997 4.36069 -18.8462 +7200 6 19.725 28.7952 8.44488 15.8543 2.58223 -4.45186 +7201 4 19.5131 27.8757 8.63421 -2.81313 1.38303 -4.16069 +7202 4 20.6983 28.808 8.54393 -13.7447 6.84799 3.59225 +7203 6 20.0995 21.6275 25.9249 -17.5249 50.4223 5.09745 +7204 4 20.7082 22.0204 26.5908 -8.84326 -18.264 -10.6066 +7205 4 19.3931 22.3347 25.9239 13.215 -30.9895 -3.48111 +7206 6 12.7711 16.1006 22.7986 17.0661 -2.75106 -3.7002 +7207 4 12.1316 16.7784 22.5952 -11.3059 6.43976 -4.8982 +7208 4 12.4647 15.3033 22.3372 -2.13756 9.04884 6.71194 +7209 6 7.09175 27.2069 17.991 -23.617 26.2366 -1.29155 +7210 4 7.8076 26.6007 17.9383 20.2011 -26.8554 -5.74897 +7211 4 7.19403 27.792 17.2318 3.33647 -0.0238245 -0.788587 +7212 6 32.3975 8.68618 34.8629 3.54321 22.8272 16.3539 +7213 4 32.7738 9.06402 35.707 -18.9002 -9.48773 -27.5474 +7214 4 31.4989 9.0701 34.6771 23.7457 -9.58556 9.46102 +7215 6 50.3515 28.2186 17.5351 -6.87553 0.519429 12.9107 +7216 4 50.2481 27.3572 17.999 6.5408 9.8464 -12.2276 +7217 4 51.0722 28.1417 16.8919 -2.26653 -7.3618 -1.59066 +7218 6 15.6741 32.1546 25.7968 -26.4348 -11.0143 -14.9159 +7219 4 16.4004 32.6083 26.1805 24.7846 13.6092 10.6573 +7220 4 15.1411 32.8481 25.3674 4.92309 -4.07512 11.5217 +7221 6 41.2877 22.001 29.6411 43.1174 -21.5596 15.2505 +7222 4 40.6305 22.5901 29.3541 -33.8214 23.827 -16.0773 +7223 4 40.8662 21.2212 29.998 -7.36398 -2.60921 4.02408 +7224 6 24.5416 12.7608 8.88206 5.17198 -11.9982 -20.3907 +7225 4 24.1774 13.5122 9.35398 1.69504 4.6425 -2.53241 +7226 4 24.2888 12.8675 7.94212 1.28664 -3.68024 15.0016 +7227 6 47.3025 20.1085 10.3977 1.21439 24.4816 37.2747 +7228 4 48.204 20.4596 10.4656 -0.7364 -8.12719 -10.3932 +7229 4 47.15 19.5905 9.61989 6.68365 -16.152 -23.0167 +7230 6 17.6916 14.2112 29.9613 0.736848 4.98565 -22.9932 +7231 4 16.8377 14.622 30.0672 -16.7241 9.37988 10.4211 +7232 4 18.1183 14.7557 29.2835 1.70081 -6.05446 6.16757 +7233 6 21.3481 34.5805 28.5342 -9.54463 9.82799 -20.865 +7234 4 21.5933 35.4178 28.0943 -1.05427 -4.62886 14.5387 +7235 4 21.7361 34.566 29.3968 13.4346 0.0141216 16.9261 +7236 6 35.1024 4.03924 4.01172 -45.5158 42.5484 12.3245 +7237 4 34.1858 3.89939 4.38295 32.1954 -12.7538 -7.33111 +7238 4 35.1016 5.02916 3.89259 9.91862 -26.8751 2.91657 +7239 6 29.9059 8.58368 22.6013 -13.5917 -22.6535 -48.6732 +7240 4 29.4773 8.30259 21.7189 15.3855 19.7125 42.6195 +7241 4 30.4378 7.8025 22.8052 -0.87874 9.41284 8.39762 +7242 6 9.78314 32.9658 15.9197 34.9354 -36.2496 39.6827 +7243 4 9.8463 32.0623 16.3137 -14.5131 14.3099 -26.4053 +7244 4 10.4229 33.3707 16.5321 -2.5459 17.7355 -14.0184 +7245 6 24.9212 14.2335 32.582 19.5351 -17.8621 25.1352 +7246 4 25.485 14.4356 33.3711 -14.9506 -0.509299 -20.0473 +7247 4 24.5508 15.0526 32.2925 -5.32053 16.7872 -6.18619 +7248 6 49.6539 21.965 26.2345 44.0267 25.2751 -8.97422 +7249 4 50.4399 21.435 26.5572 -22.3889 20.3635 -4.11669 +7250 4 50.0214 22.8598 25.9362 -18.5294 -37.2714 15.3372 +7251 6 39.2165 29.6282 28.7804 -1.72389 1.82743 -9.11301 +7252 4 39.3036 29.0201 29.5259 1.24025 -1.09654 1.55877 +7253 4 39.538 29.1266 28.0158 0.286751 -1.49672 5.82908 +7254 6 50.6899 34.7862 39.7499 25.3157 10.1005 12.0928 +7255 4 51.6472 34.6743 39.5192 -19.7186 -4.86584 -0.193213 +7256 4 50.1651 34.2508 39.1591 2.72681 -14.2758 -14.8682 +7257 6 29.2004 20.8742 19.5261 27.9811 -3.68804 20.7377 +7258 4 30.1466 21.1247 19.5553 -9.39276 -2.96688 2.79863 +7259 4 28.9246 21.1497 18.6738 -22.5466 15.5983 -24.0329 +7260 6 45.8438 1.42491 21.3861 -37.1737 6.40486 -10.0566 +7261 4 44.9885 1.11968 21.7285 6.97513 -0.0444158 -7.72874 +7262 4 46.4438 0.92117 21.8904 34.782 -15.8409 16.3481 +7263 6 26.1011 5.84859 12.9885 -16.9285 4.46913 -7.38549 +7264 4 26.5547 5.08441 12.6375 7.71787 -14.9735 6.0022 +7265 4 25.1614 5.66972 12.8036 4.71997 0.43883 -1.19571 +7266 6 9.00669 19.0403 23.7238 12.8928 30.373 -14.6892 +7267 4 8.06593 18.9071 23.7945 -12.9763 -5.98489 5.20443 +7268 4 9.0473 19.9093 23.2431 5.0983 -22.172 6.64837 +7269 6 47.6961 14.1782 40.0269 19.0377 9.97795 -11.4729 +7270 4 48.5222 14.3512 39.5239 -16.7083 -4.37767 10.6105 +7271 4 47.3795 15.0553 40.2888 -5.04524 -6.44815 -3.81417 +7272 6 47.9985 19.7874 0.500962 -66.9165 -27.0064 -39.4066 +7273 4 48.5513 19.9496 1.22397 26.1904 -2.55385 45.3318 +7274 4 47.2789 19.103 0.704655 34.6798 29.0788 0.973802 +7275 6 27.1606 39.6013 31.4318 -10.4761 -55.491 -38.6851 +7276 4 26.8926 40.2811 32.0159 -13.7359 20.3686 20.1783 +7277 4 26.3709 38.9998 31.2101 25.3937 25.349 18.055 +7278 6 20.7209 15.2822 27.3078 -0.805435 -7.71632 -8.78017 +7279 4 19.7876 15.3781 27.0487 8.25469 13.9731 2.34115 +7280 4 21.2532 16.0335 26.9925 -16.2498 2.55153 -4.46604 +7281 6 53.2722 3.12643 19.6849 41.3384 49.6686 7.26214 +7282 4 52.533 3.74254 19.7043 -8.02663 -2.92583 -3.0848 +7283 4 53.0086 2.23956 19.6703 -22.4403 -46.3419 -2.11618 +7284 6 40.7531 33.3786 24.0219 13.5521 -1.60379 23.9632 +7285 4 41.5067 33.1664 24.6167 -8.75803 3.71621 -14.936 +7286 4 40.1104 32.6626 24.1628 3.50492 2.6284 -2.95087 +7287 6 50.2066 37.8896 21.3771 44.4561 61.7722 -19.2089 +7288 4 50.9779 37.3435 21.496 14.3962 -14.5259 7.12428 +7289 4 49.4598 37.4098 21.5582 -59.0635 -51.549 13.7135 +7290 6 41.3233 2.3412 21.9924 -16.3503 12.7858 19.6024 +7291 4 41.3426 2.52207 21.0679 5.97541 2.4567 -21.4637 +7292 4 40.4663 2.75609 22.2585 17.532 -18.0725 0.252127 +7293 6 3.68867 21.2779 14.3383 -14.5707 42.5 -35.9941 +7294 4 4.12477 21.855 14.9587 9.56216 12.6885 8.47194 +7295 4 3.77328 20.4352 14.6935 9.76412 -50.205 23.6517 +7296 6 34.2782 11.1533 36.6146 -6.03132 -23.9347 13.7336 +7297 4 33.9924 10.5436 37.3334 13.9996 -4.78487 -21.5854 +7298 4 34.1172 11.978 37.0322 -7.62349 27.2634 9.28858 +7299 6 24.0533 21.9225 23.4615 4.73517 -5.47775 13.1649 +7300 4 23.9978 21.53 22.5886 6.00444 -6.53009 -8.74438 +7301 4 24.605 21.2935 23.9896 -10.4931 14.2472 -9.63662 +7302 6 18.8931 0.346665 4.41951 -1.70081 19.9518 7.76538 +7303 4 18.8368 41.3461 4.13842 4.04101 -8.25805 2.22226 +7304 4 19.3845 0.416823 5.25819 -4.2619 -8.11151 -12.0763 +7305 6 1.61167 7.82777 17.7295 14.4633 -7.55708 2.21629 +7306 4 1.68315 6.88308 17.5181 0.421421 7.02752 -3.81945 +7307 4 0.776664 7.94842 18.1735 -9.56642 1.01884 2.20602 +7308 6 9.88587 31.542 26.4865 27.4574 -58.0414 -32.6279 +7309 4 9.74723 30.8294 25.7579 9.18818 32.443 34.13 +7310 4 9.16596 32.1271 26.4328 -35.6644 31.0992 -1.66616 +7311 6 46.989 33.006 20.3636 -11.9681 -37.8677 44.1235 +7312 4 47.0707 32.5253 21.2626 7.56487 31.1056 -35.1941 +7313 4 46.435 32.3629 19.8924 4.61548 9.19147 -10.8851 +7314 6 49.5457 29.2916 21.3977 -38.7846 4.15079 -24.0209 +7315 4 50.3477 28.8236 21.2219 24.323 -7.55681 13.7085 +7316 4 49.5468 29.8542 22.1736 14.9668 -0.936193 10.2574 +7317 6 13.5153 31.8979 19.1528 13.8675 8.3184 29.6787 +7318 4 12.8458 31.9825 19.8587 16.0999 2.21739 -7.32054 +7319 4 14.3406 32.2634 19.5906 -25.0701 -6.26478 -24.6616 +7320 6 46.633 34.1066 16.9257 -0.036059 -36.1463 20.7227 +7321 4 46.8492 33.9929 15.9997 3.99258 8.43366 -10.882 +7322 4 46.9059 33.2223 17.3084 -4.9703 29.3867 -9.59361 +7323 6 19.7609 39.5392 2.42166 -7.20248 -0.896063 -14.0911 +7324 4 20.5606 40.0527 2.5788 -3.5749 4.99115 -1.28658 +7325 4 19.2738 40.0463 1.72337 11.6568 -15.7424 21.4794 +7326 6 16.5329 9.39795 28.3065 -12.6095 -8.72502 6.68605 +7327 4 16.4075 10.3536 28.3648 10.1088 3.80195 -3.74389 +7328 4 17.4502 9.20269 28.1082 11.2813 2.72217 -1.81406 +7329 6 3.0433 33.3643 8.96425 -4.92886 23.6682 -21.9772 +7330 4 2.41869 34.0757 8.74286 -2.57616 0.180013 17.6579 +7331 4 3.16376 33.0029 8.08154 7.55925 -16.3918 2.91827 +7332 6 49.6751 28.308 0.201579 -29.5359 7.30765 2.58258 +7333 4 50.5733 28.3754 41.8671 34.4717 0.327786 -9.88202 +7334 4 49.5726 27.4715 0.657175 -2.26504 -2.01296 8.34302 +7335 6 1.41619 6.84354 30.4994 -10.3235 0.0954103 3.42179 +7336 4 1.63397 7.74222 30.8225 4.19995 -13.4757 3.05915 +7337 4 0.761793 6.45905 31.124 14.5617 20.0187 -8.0296 +7338 6 19.7679 9.42131 33.717 -3.22882 -6.25654 -44.8315 +7339 4 19.9145 8.46604 33.7746 1.8774 1.59257 2.48781 +7340 4 19.5751 9.55831 32.7323 1.24521 6.76178 40.819 +7341 6 26.1724 11.919 3.61074 17.7641 10.7445 -19.8393 +7342 4 25.5356 12.1934 4.24073 -14.9718 14.8208 22.8097 +7343 4 26.0423 10.983 3.54915 1.55706 -20.7566 2.99847 +7344 6 33.2542 2.1444 18.2116 -1.15587 48.9982 3.93816 +7345 4 32.886 2.96086 18.6548 6.67205 -21.4839 -22.8104 +7346 4 32.6761 1.46025 18.493 -13.9253 -19.4899 6.26155 +7347 6 1.55797 29.1194 15.6221 -22.3111 36.2637 61.7506 +7348 4 0.853719 28.5449 15.936 -7.71843 6.28063 0.384394 +7349 4 1.90648 28.6788 14.9107 30.7784 -39.3832 -62.5327 +7350 6 41.7311 4.10421 39.5944 -40.7328 36.7616 -42.7174 +7351 4 41.3817 4.81242 38.923 27.6667 -38.3892 36.6931 +7352 4 40.9025 3.64602 39.8145 11.2401 -8.56921 5.26404 +7353 6 28.6823 41.7982 21.1955 47.2047 1.42594 -8.59686 +7354 4 29.177 0.720645 21.3267 -21.6507 -0.473723 0.486784 +7355 4 29.4617 41.2314 21.0003 -26.4876 -3.65191 3.02858 +7356 6 11.643 12.3982 35.4482 -35.2927 22.3423 -20.2863 +7357 4 11.5968 12.2307 36.3713 6.75035 -5.55932 30.2124 +7358 4 12.5522 12.401 35.2267 32.0712 -2.0845 -6.40416 +7359 6 9.80556 12.056 0.297197 42.0735 31.0338 -28.3715 +7360 4 10.6577 12.4693 0.65483 -33.0881 -22.384 -10.4034 +7361 4 9.20254 11.76 0.941289 -12.1624 -10.8407 36.4861 +7362 6 48.1632 12.393 9.2137 2.43833 7.21341 -5.5951 +7363 4 48.4522 11.811 8.50685 -9.57081 -7.25037 -8.94466 +7364 4 48.8896 12.3474 9.83523 7.41749 2.43397 12.8852 +7365 6 20.1331 24.378 18.9556 11.9182 2.36756 -38.9603 +7366 4 19.4372 23.8368 18.5171 17.2732 8.77886 9.60074 +7367 4 20.7988 24.6336 18.2364 -23.7637 -10.2166 26.3276 +7368 6 16.5494 31.2838 16.4573 -15.9423 3.69088 33.2062 +7369 4 16.5519 32.1922 16.7594 11.1434 16.9832 -11.781 +7370 4 16.1476 30.8867 17.2522 1.55385 -15.8871 -15.2552 +7371 6 1.78983 14.6435 36.2904 4.99553 5.58283 2.2492 +7372 4 1.04893 14.2282 35.8708 -13.8588 -3.35469 -16.6141 +7373 4 1.66905 14.392 37.2023 2.39459 2.07051 19.2387 +7374 6 4.37166 29.2153 29.5914 5.79168 20.1405 -19.3585 +7375 4 4.91557 28.7254 30.2154 7.17051 0.117226 5.39869 +7376 4 4.91513 29.9512 29.1891 -14.7291 -26.607 12.32 +7377 6 43.6969 0.237019 22.6594 -7.19613 -4.49497 -5.57098 +7378 4 43.0237 0.783547 22.2316 -12.2242 -6.81623 2.03469 +7379 4 43.4415 41.2053 22.5454 5.15142 14.113 -1.35906 +7380 6 52.5052 40.9917 27.2414 -4.0762 -16.2903 -30.037 +7381 4 52.8129 40.7577 26.3208 -10.5132 10.5144 20.9332 +7382 4 53.295 41.2999 27.6882 6.37269 9.42971 1.77711 +7383 6 25.5785 23.9088 27.7352 -29.163 -0.147769 2.09076 +7384 4 24.7169 24.3904 27.6009 26.0068 -16.0483 4.45096 +7385 4 26.303 24.4711 27.4736 4.98376 5.99744 -3.44082 +7386 6 23.1322 17.0409 33.3147 -4.87562 4.34963 6.5261 +7387 4 23.1435 17.5188 34.1474 -0.665908 -2.26574 -1.07751 +7388 4 22.9237 16.1327 33.5379 -5.85649 -9.89669 4.05086 +7389 6 2.9235 11.8719 21.3628 -62.5775 -31.8178 -28.2901 +7390 4 2.1985 11.2347 21.6738 31.4392 30.9604 -16.9464 +7391 4 3.51176 11.9111 22.066 35.7266 4.49799 37.8533 +7392 6 2.17958 4.14491 30.0321 9.06251 -9.53771 -13.2585 +7393 4 2.15165 5.09682 30.107 -1.56529 16.7016 0.150815 +7394 4 2.7299 3.97467 29.2422 -7.5281 0.377543 4.10315 +7395 6 26.6694 30.2855 13.4776 10.1196 11.7228 27.7054 +7396 4 25.7357 30.4785 13.6549 -0.51692 -11.2356 -3.98914 +7397 4 27.0778 30.3597 14.373 -6.55394 -4.70072 -25.9179 +7398 6 24.8731 30.8123 10.8246 -35.9544 -8.06722 -7.65859 +7399 4 25.2097 30.0125 10.4324 5.41746 -9.73411 -7.41209 +7400 4 25.6149 31.228 11.1936 31.2673 18.7081 18.3938 +7401 6 53.1638 24.1184 4.51161 -10.4445 -35.9395 21.0824 +7402 4 53.5233 24.7957 3.98549 14.2054 30.1141 -21.0763 +7403 4 53.9237 23.6117 4.81383 2.71167 2.31883 7.09562 +7404 6 24.8958 4.51213 23.9931 -29.6363 -43.6073 15.3227 +7405 4 24.1339 5.1036 23.9039 18.5944 16.8193 -2.99678 +7406 4 25.7258 4.88904 23.7461 22.8138 27.5954 -9.18982 +7407 6 34.6838 1.65591 41.2514 12.8053 -23.083 -29.6978 +7408 4 35.6244 1.45761 41.0729 -14.4971 0.421146 -0.177754 +7409 4 34.7301 1.99199 0.211928 -2.47028 17.9107 34.9925 +7410 6 13.312 19.5249 16.387 18.9594 -19.3284 17.3248 +7411 4 13.9333 19.1674 15.7225 -9.24732 -4.9188 0.52103 +7412 4 13.2597 18.8166 17.0929 -3.23838 18.5958 -24.3952 +7413 6 48.698 0.181353 20.409 -0.21633 -26.9433 -24.4133 +7414 4 49.103 41.5184 19.698 -4.34753 24.5911 30.5043 +7415 4 48.7986 41.623 21.2469 8.80211 1.41451 -0.511645 +7416 6 43.0644 27.7916 11.5133 -14.5871 -6.12813 -9.0892 +7417 4 42.6 28.0105 10.6776 10.2055 -1.97818 11.3293 +7418 4 43.4908 28.591 11.8257 3.55806 4.66568 -1.20709 +7419 6 25.6909 21.365 35.1834 16.6334 21.4278 -26.2382 +7420 4 25.8486 22.0441 34.4664 -6.54449 -15.4554 28.1071 +7421 4 25.5413 20.5536 34.6727 -4.24699 7.33591 15.2905 +7422 6 44.7232 4.60607 27.7619 9.66663 0.618053 -4.25407 +7423 4 44.3234 4.00717 27.1079 -6.11804 2.34462 0.765623 +7424 4 44.3971 5.50639 27.5932 -3.06611 -6.30885 -0.545657 +7425 6 41.2897 11.4432 34.2066 -9.61739 21.0206 -8.56292 +7426 4 40.6842 11.5664 33.4581 3.14959 1.41378 -1.0752 +7427 4 41.1924 10.5195 34.3892 0.589219 -23.8889 7.33677 +7428 6 19.897 36.6492 2.04794 -32.5825 5.5481 -21.6378 +7429 4 20.6399 36.2361 2.4987 10.0826 10.558 0.716761 +7430 4 19.9026 37.6342 1.97212 14.9366 -15.8518 15.2433 +7431 6 27.4836 4.66736 6.35028 2.97665 -65.4375 -50.0742 +7432 4 27.6123 3.82169 6.79207 -3.46759 -4.72632 -9.32934 +7433 4 27.4741 5.24116 7.04108 -4.39889 64.7262 58.0755 +7434 6 16.8382 30.7844 39.9326 10.6925 -56.0648 15.7324 +7435 4 17.0186 31.2572 40.7403 -2.33579 15.7179 12.0581 +7436 4 17.0831 29.8382 40.1617 -5.04661 27.4351 -11.6424 +7437 6 51.1641 15.1933 16.3324 21.7581 16.0625 -9.079 +7438 4 51.121 16.0888 15.8936 10.5188 -25.5533 9.6052 +7439 4 52.0677 14.7794 16.1385 -37.3149 17.1399 3.28502 +7440 6 49.9904 21.2241 35.9744 20.9503 -33.7397 19.542 +7441 4 49.3714 21.5088 35.3291 -23.4605 10.1211 -23.8745 +7442 4 49.9121 20.2362 36.0002 2.40052 26.2853 0.00810801 +7443 6 34.428 0.14016 5.66944 -7.82493 37.3161 8.31948 +7444 4 34.304 0.843366 6.34479 2.68801 -11.9822 -16.4886 +7445 4 34.2591 0.582485 4.80419 9.04141 -16.6905 11.7821 +7446 6 48.3182 11.536 19.8764 -48.9228 13.3726 26.2823 +7447 4 47.7285 11.3649 20.663 34.2262 -2.74449 -19.9886 +7448 4 47.7235 12.1441 19.3775 23.4884 -14.873 -2.11476 +7449 6 4.19152 39.4305 13.3555 27.463 28.0369 44.5079 +7450 4 4.88401 39.7456 14.019 -21.6239 -15.7277 -33.754 +7451 4 3.37287 39.6897 13.8148 -3.76347 -10.7833 -11.4512 +7452 6 8.74995 16.191 8.53596 -5.05856 2.64204 -21.058 +7453 4 8.7323 16.8633 9.22906 0.669847 -0.203387 -6.91741 +7454 4 8.69158 16.6347 7.64451 3.76071 -7.46014 24.9197 +7455 6 29.0285 14.2822 26.5262 -5.84817 34.0816 17.5192 +7456 4 29.0044 15.2824 26.745 3.30971 -49.1818 -9.92417 +7457 4 28.1563 13.9159 26.7584 2.39554 12.59 0.416474 +7458 6 27.3852 14.5292 8.14264 -25.3608 8.37865 0.80053 +7459 4 26.4121 14.3996 8.08331 21.4517 0.6706 1.76752 +7460 4 27.495 15.4908 8.29449 3.73212 -17.2528 -1.50339 +7461 6 14.1265 27.2071 32.922 33.1666 19.82 -10.1122 +7462 4 14.9257 27.349 33.4618 -9.56175 -2.66902 -6.75133 +7463 4 13.49 26.8422 33.5082 -21.5238 -13.7689 15.9353 +7464 6 31.6534 35.7886 21.2701 -36.804 -37.663 0.546332 +7465 4 32.1208 36.3742 21.8378 9.4961 28.0075 13.3964 +7466 4 30.8651 35.4592 21.7961 25.8489 11.2411 -16.1565 +7467 6 54.2152 28.7064 16.8886 2.86275 11.2554 8.9719 +7468 4 53.522 28.534 16.2345 -0.160695 -4.94794 5.34414 +7469 4 54.0581 29.6054 17.2296 -4.68599 -7.1814 -6.41975 +7470 6 9.06113 5.28333 17.1437 22.8853 4.22723 -20.1716 +7471 4 9.91678 5.17464 16.6036 -37.1561 0.754494 23.2593 +7472 4 8.77829 6.22091 17.0709 7.89423 -13.2605 2.73354 +7473 6 29.6746 9.78112 26.5507 33.4729 -21.3737 16.6755 +7474 4 30.5187 9.26436 26.5785 -19.9088 14.0899 -1.39861 +7475 4 29.3838 9.79264 27.4752 -2.64272 0.36338 -0.771294 +7476 6 44.0224 31.1718 32.1785 -15.3292 -7.28341 -3.2168 +7477 4 43.2245 30.9732 32.7283 18.2556 6.42044 -7.39667 +7478 4 44.6106 31.7763 32.6435 0.791193 1.46174 13.5451 +7479 6 53.5017 3.62335 25.1421 -16.9806 -9.67341 -1.19546 +7480 4 54.1073 4.37139 25.2408 5.33888 -0.871569 -8.36925 +7481 4 53.4976 3.25444 24.2353 14.6771 10.8199 10.1585 +7482 6 12.4523 22.8699 3.37515 20.8696 32.0548 51.3092 +7483 4 12.8715 22.0381 3.24611 3.69599 -28.8916 -15.1378 +7484 4 11.7545 23.0169 2.77653 -28.9409 -2.61743 -32.5554 +7485 6 39.4163 29.6883 0.716973 23.965 14.7498 -4.51132 +7486 4 39.9876 29.0776 0.254063 1.0023 1.05593 -7.22278 +7487 4 38.7356 29.138 1.03498 -27.9991 -12.2746 11.9106 +7488 6 13.7523 37.8126 23.0391 19.0421 33.8918 15.0049 +7489 4 14.5819 38.1972 23.3968 -5.92503 -31.5844 -9.82397 +7490 4 13.2717 38.649 23.0641 -23.8611 -10.9328 -14.9892 +7491 6 33.3489 41.2294 0.00543 12.0778 19.0207 4.12226 +7492 4 33.8966 0.076279 41.545 -17.8654 -16.3366 26.9287 +7493 4 33.5442 41.0956 0.968664 -4.79835 4.63337 -24.688 +7494 6 15.7246 3.52046 6.32841 10.9162 -8.85937 41.3038 +7495 4 14.9211 3.23468 6.78447 -0.787572 2.77727 3.3355 +7496 4 15.4617 3.69817 5.45032 -11.5336 7.63209 -33.5323 +7497 6 27.7759 30.762 5.08277 5.52432 -34.0682 -16.3389 +7498 4 28.5998 30.6312 5.57248 -10.7862 7.58152 2.34054 +7499 4 27.6688 29.856 4.68367 -5.5152 22.3618 6.77689 +7500 6 13.3283 7.58248 23.3427 28.3072 -1.43357 14.0598 +7501 4 14.1858 7.86415 22.9596 -10.8574 -4.57961 9.77565 +7502 4 12.7328 7.50745 22.6198 -18.1881 0.025746 -17.8687 +7503 6 38.3062 37.3234 27.9933 -3.63803 -3.21002 47.0561 +7504 4 38.1692 37.3862 27.0673 7.32148 -0.46048 -39.7323 +7505 4 39.0245 36.7163 28.2248 2.26391 -1.88339 -8.27891 +7506 6 35.8197 12.5511 12.093 -4.81482 -18.6185 14.0356 +7507 4 35.6024 11.6096 12.0486 2.81432 1.21601 -0.921604 +7508 4 36.2712 12.7262 11.2865 10.3444 9.98072 -18.0035 +7509 6 52.1161 23.0926 41.2793 27.7225 -3.87143 -59.8556 +7510 4 52.4049 23.0393 40.2964 5.44511 3.0042 51.4604 +7511 4 51.1968 22.9093 41.149 -26.7248 -2.75497 17.7375 +7512 6 39.5495 11.6692 16.6079 -1.17202 -14.5197 -14.1262 +7513 4 39.7784 10.7494 16.7482 7.99576 -7.98247 -12.1867 +7514 4 39.4663 11.9292 17.5115 -4.38422 20.0879 20.6825 +7515 6 0.676885 9.01905 7.96736 13.1741 22.7352 -22.4375 +7516 4 54.8016 8.92404 8.29683 -40.226 7.08621 2.19233 +7517 4 1.10058 8.31451 8.38908 28.7575 -30.4684 16.9583 +7518 6 42.3311 28.7401 39.4661 13.4879 80.877 11.2525 +7519 4 41.6603 28.5849 40.0851 -34.7426 -11.2721 27.5092 +7520 4 42.5519 27.921 39.1558 20.2132 -66.4303 -37.3003 +7521 6 38.7411 30.2829 16.2738 12.7671 5.32399 18.4704 +7522 4 38.9183 29.8748 17.1496 -6.87016 4.31697 -11.6029 +7523 4 39.4059 31.0046 16.2472 -14.9795 -12.5163 -3.03567 +7524 6 7.58764 18.0405 0.648325 -47.6574 -19.7672 20.3632 +7525 4 7.12731 17.6217 1.42737 12.1211 9.19751 -27.5752 +7526 4 8.47251 18.0259 0.938181 42.7013 4.4664 8.86021 +7527 6 33.7296 34.5938 24.1405 -3.484 -2.51034 -8.30179 +7528 4 33.5251 35.3309 23.5532 1.13599 -1.72579 4.26838 +7529 4 33.8994 34.9649 25.0137 6.47563 -1.63099 1.09862 +7530 6 16.0166 40.0494 39.5956 -28.3908 0.329345 -1.37751 +7531 4 16.9382 40.2323 39.4336 17.0381 0.329941 -6.23981 +7532 4 15.5262 40.0524 38.7513 12.3223 -0.591958 2.13513 +7533 6 4.49229 37.1333 21.8385 27.3085 -52.2253 -58.5501 +7534 4 4.66683 37.716 22.5264 18.8147 38.5231 40.56 +7535 4 5.37915 36.8768 21.3985 -41.7208 12.465 14.7942 +7536 6 39.2691 20.1288 31.3316 -12.2203 -9.20146 -18.9279 +7537 4 39.1503 20.9416 31.8094 1.95478 16.2675 16.373 +7538 4 38.6746 20.1785 30.5607 4.99665 9.53371 7.24081 +7539 6 28.5508 6.16368 32.0494 2.8072 -5.52183 -6.01527 +7540 4 29.3622 6.49582 32.4253 9.65206 -4.8896 7.96618 +7541 4 28.0782 6.98121 31.874 -4.3704 -0.58129 1.95425 +7542 6 9.33595 11.3298 38.1871 -32.8874 9.84086 11.8913 +7543 4 8.64445 12.0594 38.2922 21.8008 -26.7714 -10.0524 +7544 4 8.88851 10.5546 37.784 7.69784 20.5749 -6.72048 +7545 6 41.6095 10.4782 6.86111 8.23897 -6.62675 34.9169 +7546 4 41.7694 10.1037 7.78655 -4.1265 15.4661 -32.721 +7547 4 41.7821 11.4382 6.90291 -3.49967 -11.9299 -5.09907 +7548 6 3.12867 28.1157 17.6206 15.6267 -45.6796 29.9202 +7549 4 2.63816 28.6493 17.0564 -29.7899 29.6493 -43.0934 +7550 4 3.59757 28.7421 18.155 7.53462 9.15161 11.5693 +7551 6 39.3499 12.2397 19.2529 -23.7838 14.9837 13.9357 +7552 4 39.2457 13.2286 19.3464 7.91877 -27.4185 3.68816 +7553 4 38.6075 11.8387 19.7677 15.6586 5.94778 -12.3856 +7554 6 2.78491 9.11686 31.712 -26.5503 -22.4732 34.9375 +7555 4 3.2978 8.41451 32.2045 -9.27186 19.8876 -17.5091 +7556 4 3.27525 9.5282 31.0263 27.6548 6.40843 -16.0242 +7557 6 47.0993 34.3062 24.1668 40.213 25.5871 3.96938 +7558 4 47.8652 34.9011 23.9742 -8.40565 -28.0457 9.8184 +7559 4 46.4391 34.8642 23.795 -37.1496 -1.08965 -6.28687 +7560 6 41.29 35.6184 9.54316 -30.0867 29.8286 7.21591 +7561 4 40.3249 35.7138 9.72984 17.4159 -14.0538 -3.31523 +7562 4 41.5907 36.542 9.70742 6.71087 -21.892 -10.0971 +7563 6 20.4656 31.4513 3.14505 -29.4444 2.15246 21.5865 +7564 4 20.9799 31.2087 3.9226 8.79014 -0.482357 -2.15716 +7565 4 19.5517 31.5947 3.51954 23.5031 -1.57475 -20.844 +7566 6 33.2192 17.965 24.7971 19.8065 25.0952 18.1835 +7567 4 34.1598 18.0267 25.093 -16.2559 -11.4614 -7.96855 +7568 4 32.9244 18.9016 24.8301 -6.14071 -21.8705 -2.46334 +7569 6 40.1545 39.892 35.7566 -26.4952 1.03865 35.1005 +7570 4 39.554 39.7115 35.0283 3.12548 3.08468 -2.58895 +7571 4 39.5538 40.0617 36.55 23.7339 -1.54775 -30.4418 +7572 6 4.86493 34.7165 16.5037 -1.18866 4.83191 -8.79653 +7573 4 4.98021 35.6639 16.3239 -2.48039 -7.07182 -3.79473 +7574 4 5.57973 34.27 16.0245 9.17482 -2.77359 5.31354 +7575 6 19.1203 11.0308 26.5475 4.8369 12.9311 -1.38474 +7576 4 19.2948 10.8261 25.6303 -10.7878 -2.53157 -9.81197 +7577 4 19.6222 10.3806 27.0285 -0.932765 -12.0852 11.9627 +7578 6 54.013 13.9266 34.7866 19.735 -12.4153 18.0126 +7579 4 53.1377 14.0488 35.1524 -10.4928 -1.09871 -13.0068 +7580 4 53.982 14.1469 33.8595 -3.66316 10.2302 -11.2602 +7581 6 1.83695 20.649 5.20524 25.5491 14.9074 -17.0883 +7582 4 1.35705 19.8566 4.90021 2.5306 9.60758 -2.11708 +7583 4 2.48138 20.9466 4.48633 -27.5057 -15.388 16.1855 +7584 6 22.2484 0.089789 14.2543 15.3573 -11.1234 0.0573231 +7585 4 21.4821 0.622149 14.4313 -9.66168 8.29964 10.305 +7586 4 22.7606 41.8363 15.0657 -14.7435 5.42194 -5.09127 +7587 6 4.9437 7.03924 24.7311 13.2528 -2.19763 7.32506 +7588 4 4.13251 7.3412 24.2993 4.98795 -3.92941 -4.4547 +7589 4 5.31694 6.26419 24.274 -9.7854 5.58222 5.45409 +7590 6 41.4768 20.8727 34.9433 -10.8141 32.3245 17.6117 +7591 4 42.0721 20.1596 35.0936 18.2074 -21.2429 -2.25611 +7592 4 41.5511 21.3995 35.7803 -3.93981 -14.5735 -18.4651 +7593 6 28.2063 1.73787 31.7361 2.56856 -6.63991 -21.6427 +7594 4 27.5833 1.04583 32.0206 5.931 11.5306 2.70007 +7595 4 28.427 2.28487 32.4907 -6.15569 2.19681 12.1249 +7596 6 16.8959 27.3728 36.9936 3.36683 -9.46076 -21.7251 +7597 4 17.1861 28.0765 36.4018 -0.835984 6.87178 9.62195 +7598 4 17.1491 26.5677 36.4964 -8.72142 5.45523 11.8618 +7599 6 26.8172 38.095 8.33253 -7.04389 15.4319 43.7153 +7600 4 26.4231 38.1886 9.22965 13.1827 16.4204 -18.9623 +7601 4 26.752 37.1697 8.26194 2.82704 -45.8494 -18.5449 +7602 6 26.6605 33.8021 23.2109 -14.7721 -8.40788 6.86704 +7603 4 27.1437 33.2455 22.6071 1.71839 -3.83047 -13.3917 +7604 4 27.3181 34.0928 23.8234 13.6598 11.6313 12.8928 +7605 6 10.2089 27.1103 30.2249 26.5091 -20.839 -19.8889 +7606 4 10.2296 28.0525 30.305 -4.35446 23.414 7.17464 +7607 4 10.909 26.9135 29.5485 -17.3927 5.996 19.4297 +7608 6 47.8678 12.6068 5.01236 10.3402 17.2727 14.3835 +7609 4 48.2471 13.4466 5.34357 -15.5974 -13.1618 -9.91905 +7610 4 48.2827 11.9587 5.58273 0.760146 -12.24 2.37579 +7611 6 53.3401 24.5564 22.1447 -33.4845 3.13007 15.4457 +7612 4 53.2868 24.6175 23.1082 -8.50106 -5.88574 1.47389 +7613 4 54.2491 24.6404 21.954 37.9576 4.9603 -12.0283 +7614 6 29.4115 10.751 19.3682 47.3718 16.1602 -3.46693 +7615 4 29.23 9.95501 18.9095 -1.62259 -22.6341 -18.5903 +7616 4 28.6164 10.8767 19.816 -47.8248 15.8998 30.722 +7617 6 39.4772 14.9486 19.552 50.4126 11.9025 42.2912 +7618 4 40.3976 15.2789 19.8627 -47.7598 -21.1435 -8.50237 +7619 4 39.4723 15.2512 18.6704 -12.4406 15.8155 -35.6919 +7620 6 32.8813 15.9868 22.8125 3.47488 17.0872 -31.9433 +7621 4 33.0166 16.4922 23.6113 -1.39335 7.20309 14.6349 +7622 4 32.7144 15.0846 23.0256 -4.37432 -22.045 19.0968 +7623 6 30.558 1.96704 21.5074 2.70654 -4.91402 -0.473851 +7624 4 30.6739 2.00523 22.4671 5.88049 3.20632 -1.97238 +7625 4 31.3728 1.59666 21.1136 -11.8747 6.17773 7.16567 +7626 6 0.976021 12.0022 3.31788 -2.33791 2.9975 -11.3542 +7627 4 1.23381 12.945 3.27167 -8.13702 -10.1344 5.41434 +7628 4 1.05317 11.6593 4.21576 7.83216 6.74936 8.77967 +7629 6 32.1417 30.4028 20.7928 -10.9162 7.90477 -12.8705 +7630 4 32.9583 30.6218 20.3315 4.32484 3.35409 -0.814586 +7631 4 31.4267 30.7883 20.2371 10.7836 -11.8724 10.7529 +7632 6 5.37233 35.5196 8.9984 1.65786 -0.655334 17.0686 +7633 4 5.15633 35.7733 8.10502 -8.52999 -6.98357 -10.434 +7634 4 4.86772 34.7263 9.2434 -1.9757 2.02155 -6.9424 +7635 6 49.9125 13.0387 32.1973 27.4626 15.6741 -16.8517 +7636 4 50.6053 12.9182 31.4733 -26.2683 -0.306922 26.3637 +7637 4 49.2504 12.3613 32.0764 -3.75185 -11.6573 -0.304044 +7638 6 4.31386 24.093 1.57868 7.45772 -24.8618 -14.5348 +7639 4 3.64218 24.7342 1.7864 -13.9986 8.43803 -2.25361 +7640 4 4.01488 23.4668 0.872394 2.3276 24.3041 16.4513 +7641 6 44.1644 38.1215 12.3455 -22.0907 -25.3739 20.9172 +7642 4 43.5152 37.5597 12.8481 16.1408 4.83783 -17.5332 +7643 4 43.8688 38.9961 12.5721 5.21907 21.319 -3.3764 +7644 6 44.6817 17.3326 22.8013 48.0619 -4.56356 -9.07637 +7645 4 45.2902 18.0584 23.1498 -22.5072 -22.7727 -5.21409 +7646 4 45.2932 16.6008 22.4593 -20.015 30.0459 19.1644 +7647 6 20.3678 11.7042 19.6638 18.1083 -41.9451 -24.672 +7648 4 19.8947 12.3606 20.1264 -14.0753 36.8205 14.9866 +7649 4 20.5011 12.0109 18.7433 -0.799123 0.72776 10.7716 +7650 6 4.45477 15.3976 36.1886 1.65809 1.26145 11.9226 +7651 4 5.09661 14.6681 36.098 -4.75494 5.61497 -10.92 +7652 4 3.56051 15.0123 36.2095 4.93474 0.57137 -3.51241 +7653 6 44.8032 39.5214 30.1736 10.2403 3.65831 -28.7798 +7654 4 44.6649 39.352 29.2044 0.893291 -3.4354 28.9244 +7655 4 44.1834 39.0261 30.7164 -9.9549 -0.503639 -4.51595 +7656 6 30.0776 3.52093 11.3186 -8.111 -9.63673 -5.93937 +7657 4 30.5797 4.33725 11.0789 -10.9699 -19.7375 -4.73534 +7658 4 29.9808 2.85663 10.5812 14.022 21.906 10.2093 +7659 6 25.6241 24.8658 16.1333 6.68449 -9.57605 -29.1286 +7660 4 26.5694 24.8046 15.8818 -8.72523 1.1772 17.1704 +7661 4 25.5267 25.1318 17.0381 12.8553 5.85519 26.3055 +7662 6 36.8177 29.8487 20.6561 -37.5479 -3.0004 33.0202 +7663 4 35.926 30.1959 20.4157 18.2985 -1.907 -0.407745 +7664 4 36.6716 29.3784 21.5423 12.7247 15.2026 -39.3319 +7665 6 52.2186 17.0658 38.3042 -7.89215 -38.4825 28.5148 +7666 4 51.4916 16.4675 38.6484 24.7832 21.5941 -14.95 +7667 4 51.8247 17.6139 37.6469 -10.8917 8.73986 -12.7264 +7668 6 3.82879 23.6249 29.8747 0.0111461 24.9347 -0.194649 +7669 4 4.57266 23.2964 29.3507 7.82142 7.55197 5.89536 +7670 4 4.12107 24.4472 30.3626 -2.93665 -31.334 -6.69289 +7671 6 6.37221 19.8955 41.0814 -10.7405 10.6187 0.232117 +7672 4 6.67124 19.2607 41.7286 9.67887 -12.4754 3.81392 +7673 4 6.49825 20.7419 41.4991 -1.14685 10.1205 10.9238 +7674 6 28.9128 38.9237 35.3305 22.4394 21.6131 25.3888 +7675 4 28.4594 38.2476 34.8641 -13.9867 -26.2755 -20.0992 +7676 4 29.711 38.4973 35.7105 -10.7836 3.83713 -8.57645 +7677 6 1.06675 30.3059 34.4729 25.4378 -4.31804 35.0042 +7678 4 0.780778 29.8064 33.7399 -5.76855 -22.7951 -38.2413 +7679 4 0.490797 31.0506 34.5199 -18.1513 16.5028 -0.872558 +7680 6 26.4359 22.0299 20.4363 32.8101 13.5123 0.44111 +7681 4 27.364 22.3315 20.3938 -13.8894 -16.1779 0.0777322 +7682 4 25.9647 22.8561 20.3336 -19.4369 -2.2953 -2.32927 +7683 6 3.94837 18.6341 22.6823 32.7056 -17.0211 23.8668 +7684 4 4.7768 18.6814 23.2391 -24.3494 -8.73456 -16.7413 +7685 4 3.72444 19.5457 22.6416 -13.4357 33.3979 -9.86072 +7686 6 6.89585 39.3162 26.9832 -46.5714 7.68979 7.72716 +7687 4 6.93923 40.0377 27.612 28.7888 3.33438 12.9127 +7688 4 5.92214 39.2413 27.0287 16.4173 -5.75108 -11.0421 +7689 6 43.9872 41.7521 26.5322 17.8857 -12.0416 -16.5154 +7690 4 43.9509 0.2718 27.3768 -8.40653 9.77536 19.5266 +7691 4 43.1315 41.809 26.1188 -22.0408 9.50446 -3.00799 +7692 6 31.7113 29.5746 16.987 -20.6637 1.93471 5.13032 +7693 4 31.02 28.863 17.0135 12.5534 15.6398 -7.64726 +7694 4 31.2508 30.4156 17.2234 10.2038 -24.3383 2.42367 +7695 6 46.2561 10.9612 15.5385 0.577538 -38.7584 22.3134 +7696 4 45.3251 10.7213 15.4484 -5.02058 7.03855 -0.171485 +7697 4 46.6569 10.0824 15.7727 -2.20865 28.2857 -11.3723 +7698 6 36.5827 15.0435 25.8168 31.2067 4.61936 9.12499 +7699 4 37.3875 15.5118 26.1911 -33.209 -18.98 -14.6655 +7700 4 36.1295 14.6889 26.5897 -4.0863 -6.05063 3.58839 +7701 6 47.2722 22.6647 6.13576 -8.17133 27.0247 -35.749 +7702 4 46.6204 23.3224 5.77393 14.8224 -22.4366 13.8178 +7703 4 46.9842 22.4705 7.01441 -4.98592 -2.25738 16.061 +7704 6 27.5378 39.6651 17.8024 -2.94112 10.9701 -10.3343 +7705 4 26.5953 39.7232 17.618 -8.53785 1.10642 -8.0722 +7706 4 27.5664 39.1005 18.5557 5.38052 -12.9364 18.2146 +7707 6 14.0357 27.9675 36.8848 11.7171 -39.9071 2.25396 +7708 4 13.4367 27.1833 36.8225 11.7441 28.4062 -4.63591 +7709 4 14.9372 27.5486 36.8957 -17.1932 18.8386 1.76957 +7710 6 33.7684 13.0304 13.8649 26.1794 -24.2655 -33.187 +7711 4 34.6252 12.938 13.363 -28.3858 22.7045 20.1179 +7712 4 33.4338 12.1329 13.7478 -6.61414 4.24237 14.4002 +7713 6 3.3826 17.477 1.97134 -12.4208 -32.1468 -36.6933 +7714 4 2.99872 16.7111 1.40376 19.9781 39.313 29.0042 +7715 4 3.44044 18.2025 1.33186 0.336883 0.1642 8.16047 +7716 6 27.5407 2.76347 36.4361 37.1152 10.6125 -5.75272 +7717 4 28.1274 2.95293 35.6781 -8.18971 -2.06925 12.0999 +7718 4 26.7696 2.41682 36.0063 -15.232 -6.73967 7.66134 +7719 6 21.3092 1.20818 18.7198 27.6808 -56.7894 17.4302 +7720 4 20.9088 2.03925 18.6129 -17.8717 42.912 1.2548 +7721 4 21.1846 0.863131 19.6413 -10.5106 12.8119 -18.3621 +7722 6 11.8887 16.6751 29.3062 -13.3787 -14.7829 9.57092 +7723 4 10.9992 16.5416 28.8882 19.0949 3.10928 11.6713 +7724 4 11.8781 16.1991 30.1864 -3.15773 18.3703 -25.9576 +7725 6 15.9606 29.4505 29.6321 19.1231 40.0535 19.8704 +7726 4 16.8787 29.2659 29.409 -1.79459 -0.812108 -5.15406 +7727 4 16.0576 30.3074 30.1528 -10.887 -31.0851 -11.0284 +7728 6 42.9296 7.03459 4.51333 33.3286 4.63812 8.33203 +7729 4 43.4321 7.52085 3.82302 -14.3213 -8.56549 9.51251 +7730 4 43.6462 6.74019 5.1384 -26.8219 -5.28882 -15.1101 +7731 6 46.4281 26.3352 18.5118 -29.5226 20.9834 -10.3716 +7732 4 46.6343 27.1839 18.9751 -0.829481 -30.2492 -9.82569 +7733 4 45.6684 26.5824 17.9287 20.9241 -8.5113 7.46212 +7734 6 26.8394 31.9326 30.1088 25.5924 -16.6135 -32.4851 +7735 4 27.2107 31.0232 29.8435 -20.3392 35.4128 12.4615 +7736 4 26.6802 32.4017 29.2373 1.48159 -21.8349 29.7067 +7737 6 19.4878 37.6142 31.2562 -14.4543 3.58951 24.8148 +7738 4 19.156 36.8698 30.7235 -3.28844 3.66685 11.8368 +7739 4 19.1019 37.6358 32.1884 8.87174 -10.6544 -29.6345 +7740 6 52.3726 32.7139 12.8078 14.0751 37.5782 -32.6023 +7741 4 51.9367 33.0602 12.0031 -5.44932 -19.1877 9.81768 +7742 4 53.2329 33.1776 12.7347 -13.6236 -17.9256 14.0183 +7743 6 6.74161 9.28353 24.0307 -13.1667 -36.0519 9.75632 +7744 4 6.38029 9.61276 23.1997 0.718458 -3.76261 -6.90188 +7745 4 6.16941 8.51095 24.2946 11.6474 19.2019 -8.42102 +7746 6 39.7455 39.5612 25.4988 -8.346 1.54154 -0.59194 +7747 4 39.7035 38.6168 25.2826 0.975023 6.38379 0.651723 +7748 4 38.8484 39.7767 25.8082 2.0142 -6.85885 -0.770105 +7749 6 24.0762 14.0053 21.1456 13.3165 -18.5501 -35.6859 +7750 4 23.5798 13.5675 21.8237 -9.9014 -1.44375 19.5869 +7751 4 24.3047 13.2647 20.5221 -3.72657 29.1491 15.9401 +7752 6 5.19759 41.7876 24.8616 10.5329 -30.3401 13.9713 +7753 4 5.96107 0.070496 25.4117 5.01198 -1.48177 -8.04364 +7754 4 4.80364 0.70791 24.6471 -6.87058 19.426 -10.6286 +7755 6 42.3635 20.8692 21.2747 32.7502 -34.6644 -10.1673 +7756 4 42.4242 20.4785 22.1458 -3.583 2.66194 10.2144 +7757 4 41.7418 21.5604 21.318 -29.6652 28.4695 2.24145 +7758 6 48.2477 15.3659 33.5923 1.80889 -1.28345 12.5443 +7759 4 48.6164 14.6993 32.9992 0.330488 0.612282 -4.05403 +7760 4 47.6342 15.9182 33.1009 -4.13716 0.340872 -13.8372 +7761 6 46.021 38.2915 16.5867 23.3569 13.4435 24.034 +7762 4 46.6714 37.7063 17.0526 -15.1447 15.3639 -15.4724 +7763 4 46.2171 39.2064 16.9307 -10.1858 -20.2136 -16.2853 +7764 6 4.64649 28.484 21.3661 -49.4423 -36.8464 -34.122 +7765 4 5.0061 28.857 22.1388 17.5694 9.2675 37.6073 +7766 4 4.11403 27.6656 21.6036 24.8595 24.6655 -3.1651 +7767 6 20.5601 15.1658 18.389 17.6685 -18.4833 12.4376 +7768 4 20.0269 15.9148 18.1339 -10.4277 9.01273 0.992097 +7769 4 20.1375 14.696 19.1318 -1.87864 11.9594 -2.12399 +7770 6 16.2536 13.648 17.4664 -31.6255 -3.12789 -19.3987 +7771 4 16.1444 14.6075 17.6118 2.65347 -13.1818 -8.15029 +7772 4 15.6032 13.3943 16.7283 22.0135 11.6863 31.5082 +7773 6 52.4969 30.9511 18.1582 10.5176 -22.8935 27.2955 +7774 4 52.1187 31.5845 17.5724 -17.5669 13.4893 -21.7562 +7775 4 51.7599 30.5669 18.6706 14.518 10.6779 -8.97027 +7776 6 24.417 1.73185 15.7818 -6.46311 -4.24469 33.4298 +7777 4 24.2563 1.19981 16.5985 3.98325 2.24538 -18.7421 +7778 4 24.1038 2.61269 16.0335 4.13298 0.832539 -9.96215 +7779 6 23.8696 5.09384 31.0808 18.8621 -40.8234 -26.8653 +7780 4 23.8491 5.89936 31.5593 0.144588 30.2314 14.3891 +7781 4 24.8063 4.82715 30.9043 -17.3015 12.7186 6.18451 +7782 6 29.664 30.9246 0.393748 19.8337 -4.81556 23.0674 +7783 4 30.503 30.586 0.018652 -21.3617 6.75777 -1.54054 +7784 4 29.144 31.3327 41.6109 -5.17979 -0.628515 -14.2195 +7785 6 32.8496 37.8945 22.5158 10.0753 4.77658 10.1953 +7786 4 33.692 38.178 22.1563 2.67507 -3.41774 -7.7275 +7787 4 32.953 38.1222 23.4459 -10.6691 2.21895 5.00606 +7788 6 16.4801 17.3789 33.7607 -9.23434 -4.14589 -23.771 +7789 4 15.9446 17.8653 33.093 7.5539 3.01496 23.5583 +7790 4 17.136 16.9338 33.2029 1.0053 3.7812 3.66748 +7791 6 9.22576 13.3955 27.544 21.8484 -6.91303 -4.28818 +7792 4 8.36976 13.4851 27.1157 -15.2219 0.444174 10.4645 +7793 4 9.14931 12.9772 28.4181 -9.36318 7.36421 3.71477 +7794 6 43.4776 7.7356 17.2334 -9.59035 3.82748 19.1182 +7795 4 43.4092 7.74545 18.2218 0.501649 1.62452 -33.0026 +7796 4 44.4173 7.85634 17.0579 0.99974 -1.57098 -4.99047 +7797 6 22.314 24.3423 23.1668 -12.6246 5.51695 -1.93377 +7798 4 22.7955 23.5193 23.2443 6.83464 -10.1031 3.26418 +7799 4 21.5276 24.1384 22.6266 3.35813 5.31764 3.82921 +7800 6 26.0086 32.9187 32.7195 -0.756619 6.65713 -1.20686 +7801 4 26.2515 32.7095 31.8047 -0.82286 -4.52018 -0.557583 +7802 4 25.2078 32.4163 32.9092 -2.81033 -0.378904 -0.617388 +7803 6 16.9305 19.0463 7.44765 14.0068 18.7364 -6.96389 +7804 4 16.3855 19.2981 8.21028 -2.47769 1.30563 -6.88861 +7805 4 17.0815 19.8512 6.87677 -9.59141 -23.4241 18.196 +7806 6 48.1118 14.458 27.5672 -1.70385 5.14823 10.3583 +7807 4 48.0423 15.1786 26.9235 1.90686 -4.78611 -1.19899 +7808 4 48.0875 14.8765 28.4507 4.89589 -0.740891 -11.823 +7809 6 52.3863 41.7399 11.1185 2.41988 14.2085 23.7397 +7810 4 52.3863 0.193993 10.2459 -4.45976 10.8931 -22.0542 +7811 4 52.6887 0.557857 11.7005 -5.56281 -10.4239 -7.84704 +7812 6 36.3311 6.93589 12.7094 -2.38398 9.53491 -1.97617 +7813 4 36.3789 7.90344 12.827 -2.48918 -10.7733 3.15906 +7814 4 37.2588 6.6822 12.6726 5.22435 -7.00461 -0.877062 +7815 6 8.24215 20.3216 16.6719 4.98767 -5.10439 -5.65687 +7816 4 8.08588 19.3952 16.4038 -4.3079 5.82994 10.8424 +7817 4 9.2046 20.4438 16.7199 -1.30961 -3.63404 -4.19262 +7818 6 28.7954 40.3113 12.828 -13.6179 6.23593 21.4452 +7819 4 29.5192 40.3706 12.2287 20.8327 -7.3113 -16.8089 +7820 4 28.5554 39.3777 12.9053 -3.26344 4.60902 -2.65931 +7821 6 18.1473 11.8343 16.9395 -0.80483 -16.2761 12.6256 +7822 4 17.6848 12.6388 17.2294 4.62203 -2.59462 -3.9508 +7823 4 19.0947 11.9922 16.9221 7.13726 16.095 1.27241 +7824 6 30.8869 17.4142 21.504 -52.7305 12.2285 -31.3088 +7825 4 30.1482 16.8222 21.1884 27.1221 10.2955 22.0665 +7826 4 31.6253 16.8731 21.7262 19.9221 -18.6281 13.9623 +7827 6 34.8012 19.4194 37.9626 16.1869 22.0253 -15.6613 +7828 4 34.8979 20.1386 37.2822 -2.41662 -18.1877 20.3873 +7829 4 34.2105 18.7604 37.6043 -6.15487 -8.04615 -10.7113 +7830 6 35.8208 16.8923 29.2032 22.3367 20.7443 33.8648 +7831 4 36.613 16.5252 29.6466 -9.20578 0.119567 -6.22754 +7832 4 35.5382 16.2441 28.5922 -11.4717 -30.451 -21.7041 +7833 6 3.04279 32.2854 6.33929 -26.9238 12.3825 -4.69033 +7834 4 2.12647 32.146 6.0594 1.42689 6.59766 6.64942 +7835 4 3.42261 31.4611 6.08203 25.9982 -20.506 -0.598367 +7836 6 26.7966 41.6596 10.1464 32.6739 -10.8326 9.81865 +7837 4 27.6955 41.4226 9.79016 -25.5431 4.71255 4.81996 +7838 4 26.9918 0.01593 11.0584 -5.4334 2.64263 -3.14356 +7839 6 52.266 24.562 24.8685 -9.42886 0.421982 -6.72882 +7840 4 51.3046 24.7615 24.9057 17.7877 -5.82089 5.23086 +7841 4 52.6568 24.8699 25.6923 -4.67896 5.24225 9.60646 +7842 6 22.6938 22.6511 33.5751 -3.71591 7.58927 38.5179 +7843 4 23.2073 23.1628 34.2375 -1.81825 -3.74423 -24.5931 +7844 4 21.9227 22.4274 34.1227 -1.3969 -6.37714 -14.1968 +7845 6 10.6508 14.2453 33.0462 38.3111 -19.1724 1.31243 +7846 4 10.5904 14.9583 32.4175 -11.7628 10.624 -9.61146 +7847 4 9.79743 14.0525 33.3881 -28.4056 0.15536 2.16046 +7848 6 21.8963 10.8464 11.5207 26.0054 2.65771 10.2946 +7849 4 22.8204 10.615 11.7238 1.04479 5.32162 -7.74354 +7850 4 21.5123 10.8483 12.397 -14.7134 -4.5627 10.8449 +7851 6 38.3602 6.02493 25.8481 -1.65407 -6.16467 0.326828 +7852 4 38.011 6.16356 26.7557 4.19059 11.4538 -13.8011 +7853 4 38.4332 6.8537 25.3449 -2.0709 2.94932 12.5244 +7854 6 30.9335 26.6426 38.5759 12.2579 -6.52521 -50.146 +7855 4 30.9725 26.4832 39.4983 -1.12433 -12.3748 34.5417 +7856 4 31.1634 25.7976 38.1184 -10.2303 12.0451 18.6771 +7857 6 30.1758 14.6176 35.4883 -28.0954 45.5198 -22.6945 +7858 4 30.377 15.4621 34.9933 16.3957 -28.3235 8.82257 +7859 4 29.2055 14.6893 35.4544 11.1506 -16.8188 10.9927 +7860 6 12.5393 37.2199 16.9523 -39.8589 -5.36999 -7.27655 +7861 4 12.8749 37.9509 17.4338 22.3846 22.4284 20.6781 +7862 4 13.1653 36.5135 16.9845 23.2041 -13.3789 -0.375674 +7863 6 27.4265 21.5607 37.7225 20.8747 -12.9562 -0.181201 +7864 4 26.9326 21.725 36.9211 -12.0211 3.79264 -7.84561 +7865 4 27.0206 21.994 38.4656 -12.5008 8.35973 2.85409 +7866 6 29.6119 18.3909 12.6766 5.02953 -16.5769 27.1188 +7867 4 29.5217 18.1084 13.6179 -1.01954 6.11509 -19.9302 +7868 4 28.7057 18.4542 12.3734 -9.03627 4.70036 -1.08008 +7869 6 2.35849 15.6559 0.172343 -13.1317 26.5324 40.4931 +7870 4 1.57628 15.538 41.5798 -33.9312 2.46749 -10.4392 +7871 4 2.94928 15.1153 41.6306 46.9044 -35.3027 -23.6199 +7872 6 17.8239 25.728 4.21905 -37.6117 -8.49993 -31.7596 +7873 4 16.8718 25.6243 3.8952 33.4499 1.9374 22.526 +7874 4 18.2969 25.7387 3.3671 7.88894 5.9968 18.5236 +7875 6 41.8048 11.1855 20.2736 -2.74436 -4.31591 -6.39865 +7876 4 42.499 11.3266 19.6063 -2.31748 -7.213 6.47037 +7877 4 40.9812 11.3277 19.7997 -4.16553 7.78699 0.129723 +7878 6 38.0436 18.3822 24.0291 -8.03771 -8.75406 0.916934 +7879 4 38.3881 19.1147 24.5363 7.93091 8.32946 7.65245 +7880 4 37.8775 18.7197 23.1534 1.15748 3.59885 -9.88254 +7881 6 4.13949 13.9245 33.751 32.8429 -54.5446 -5.73928 +7882 4 3.27676 13.674 34.0388 -19.3763 3.63281 4.9893 +7883 4 4.61955 13.0097 33.6871 -20.752 50.0513 -2.76975 +7884 6 19.1955 19.1942 26.4999 -2.68794 -13.6734 16.0889 +7885 4 19.5301 20.0447 26.2113 2.49975 9.05121 -5.4902 +7886 4 18.8802 18.7176 25.7363 0.91839 -0.338605 -10.966 +7887 6 22.4654 26.212 25.3377 -43.9819 -31.3945 15.8492 +7888 4 22.341 25.462 24.7348 6.987 2.92742 -4.90062 +7889 4 23.2684 26.6111 25.1223 47.0594 15.091 -19.0516 +7890 6 48.8212 32.07 32.5598 -32.6217 13.0764 9.49579 +7891 4 48.8519 31.1339 32.3903 9.77015 -16.5586 -2.94571 +7892 4 49.6142 32.4858 32.2593 19.8009 3.1546 -7.06015 +7893 6 25.2092 18.0177 27.0119 4.84672 -18.7822 -3.15467 +7894 4 24.5216 17.4674 27.4199 2.41306 12.0417 3.55819 +7895 4 25.6695 17.4202 26.3966 -2.25094 9.61905 1.21472 +7896 6 1.75029 41.5558 24.9373 10.8929 -9.66126 -16.5331 +7897 4 1.94143 40.8029 24.3062 -11.1729 27.8661 22.017 +7898 4 1.33214 0.330238 24.3814 7.15774 -16.2959 10.6574 +7899 6 18.6827 11.7655 10.8523 -12.8723 -21.6642 16.1997 +7900 4 19.5636 11.9042 10.4948 -5.12175 -0.337419 -4.96303 +7901 4 18.6779 10.8452 11.2231 -2.76434 23.9208 -10.2934 +7902 6 45.6216 16.5622 4.85345 35.2391 7.72621 -8.96994 +7903 4 46.5826 16.2921 4.84248 -29.2944 1.01327 2.32041 +7904 4 45.6571 17.5026 4.56372 -8.00263 -16.2723 6.75488 +7905 6 40.6693 36.3938 24.0175 15.8353 8.34465 -33.37 +7906 4 40.8833 36.7626 23.1096 -14.2319 -6.57786 31.0793 +7907 4 40.765 35.4388 23.9669 -2.25062 -4.28397 3.06966 +7908 6 32.2103 36.323 4.961 11.3673 -15.0032 -27.5021 +7909 4 31.6022 36.0041 4.27996 -13.8963 14.3234 5.17466 +7910 4 32.9864 35.7931 4.73143 4.05858 7.46319 17.1387 +7911 6 1.60869 14.6755 10.8061 -10.0389 6.06769 39.8197 +7912 4 2.33356 15.3221 10.9109 -7.21973 -7.23845 -0.707439 +7913 4 1.19104 14.6475 11.7231 10.7485 2.93157 -30.114 +7914 6 35.0001 14.2727 28.079 63.2852 10.3217 34.449 +7915 4 34.8812 14.1453 29.0533 -4.19424 -2.10072 -23.3494 +7916 4 34.1798 14.2655 27.6589 -51.5469 -5.32036 -14.2309 +7917 6 54.7125 6.11605 21.8555 -14.0361 -8.25377 2.86163 +7918 4 53.7845 6.02557 22.1597 12.8111 1.82594 -4.22103 +7919 4 0.03027 6.89073 22.319 4.64766 10.0402 5.34703 +7920 6 31.7713 16.925 27.3783 -6.86907 -7.88471 17.2493 +7921 4 30.8352 17.1376 27.29 -7.38275 1.84485 -8.02972 +7922 4 32.1916 17.1776 26.567 8.49209 11.7792 -21.4891 +7923 6 14.465 28.0197 11.093 -4.59026 -39.5121 13.6529 +7924 4 14.1257 28.8224 11.4501 -8.46011 24.0779 0.0563038 +7925 4 14.7692 28.1802 10.1981 4.52198 5.50754 -5.24146 +7926 6 35.6475 19.4845 18.3155 9.57103 -1.809 -3.39748 +7927 4 36.1727 19.3545 19.1113 -4.74674 6.51425 2.74698 +7928 4 35.0476 18.7267 18.3208 -0.78661 10.9943 -3.1182 +7929 6 0.909574 12.7326 15.4512 -4.00403 -44.3255 -0.361194 +7930 4 0.713888 11.7498 15.2844 2.79491 38.2978 9.54583 +7931 4 1.42535 12.7402 16.2831 -6.10996 -1.10113 -5.97882 +7932 6 52.7151 14.8297 20.9852 -8.18072 -78.4028 12.8764 +7933 4 52.2089 13.9625 20.7908 19.9141 35.1606 18.4317 +7934 4 52.3599 15.4219 20.3591 -8.09633 28.1752 -16.3986 +7935 6 7.5074 6.79303 13.6094 20.1749 -33.1825 -2.20484 +7936 4 7.51894 7.72815 13.8132 13.5555 7.5777 -3.02343 +7937 4 8.44355 6.42469 13.5879 -32.5694 21.0012 0.325521 +7938 6 12.8707 29.146 30.9458 -23.5578 15.3335 -40.981 +7939 4 12.9428 28.445 30.3111 -4.06483 -0.044806 -18.3112 +7940 4 13.2276 28.7127 31.6654 25.7046 -17.9249 62.7325 +7941 6 8.91318 29.991 35.6703 -0.0610651 3.14803 31.5119 +7942 4 8.887 30.0597 36.6571 13.1627 -14.4278 -23.4692 +7943 4 8.81345 30.9051 35.4106 0.983205 7.41015 -17.1111 +7944 6 29.2436 7.20633 5.57892 -54.0378 33.243 -15.4453 +7945 4 29.9077 6.6209 5.82325 37.3203 -38.0996 12.3519 +7946 4 28.4255 6.92245 6.05186 24.5111 10.6259 -6.90283 +7947 6 25.8948 9.2579 3.86177 -16.7921 -19.1399 -16.9328 +7948 4 26.6486 8.78935 3.46547 3.6066 2.83982 9.7025 +7949 4 25.146 8.75694 3.47524 9.6908 8.1243 10.3781 +7950 6 46.1591 19.5353 23.8511 81.1089 -3.44953 5.31324 +7951 4 47.0572 19.4192 24.3423 -46.5837 0.334518 -9.80273 +7952 4 46.5432 19.8542 23.0066 -21.4105 0.836057 1.37554 +7953 6 18.5926 35.3225 28.784 52.2521 -24.0621 1.05868 +7954 4 18.6271 36.1437 28.292 -9.91963 10.3291 -8.20284 +7955 4 19.5499 34.9756 28.7398 -42.866 14.0686 4.10052 +7956 6 27.9863 22.6413 32.202 21.6529 -11.7193 -18.2399 +7957 4 28.0891 22.9783 31.3009 1.03266 3.02954 6.56078 +7958 4 27.1414 22.9613 32.5068 -4.28354 -0.549074 4.96673 +7959 6 25.9903 18.4326 22.6797 -22.9747 -15.6034 11.3844 +7960 4 26.7869 18.8273 22.3692 24.9379 13.7229 -5.91644 +7961 4 25.7208 18.921 23.4832 11.724 -6.94511 -8.75168 +7962 6 31.1697 23.092 29.1693 -11.9745 -15.1316 21.2053 +7963 4 31.2077 22.141 28.9533 -3.34012 7.58841 -3.35467 +7964 4 31.7416 23.575 28.5808 9.8436 3.86516 -11.5721 +7965 6 36.6303 4.93142 0.48008 48.3 12.3871 -22.3067 +7966 4 36.6637 5.82298 0.895967 -3.77214 -15.5899 -6.86281 +7967 4 37.4556 4.91994 41.7793 -42.6939 0.501904 23.801 +7968 6 36.4828 20.995 10.0445 1.4409 16.9025 7.88029 +7969 4 36.442 20.1354 9.60774 -3.67605 2.90774 1.0232 +7970 4 35.8889 20.9899 10.8082 0.675338 -5.55749 -3.21659 +7971 6 50.6068 25.1826 18.3885 -34.0155 8.99756 4.28297 +7972 4 49.9165 24.7513 17.8483 3.12051 4.84127 10.9758 +7973 4 51.4426 24.9479 18.0312 23.0155 -7.64449 -5.94589 +7974 6 50.1857 39.6546 12.4249 -35.8487 -4.75972 18.1961 +7975 4 49.7435 38.8097 12.6589 9.38526 12.3917 -5.89531 +7976 4 51.0761 39.4561 12.2056 25.3285 -5.23538 -8.69122 +7977 6 30.5392 12.4112 4.81308 -24.6918 -8.37115 23.8709 +7978 4 30.0105 11.5821 4.90198 12.5687 16.0288 7.14 +7979 4 30.9611 12.2897 3.99028 20.9425 -4.88336 -30.4106 +7980 6 28.9507 15.4785 21.8764 2.88494 -37.77 16.9414 +7981 4 29.2026 14.5932 22.3105 -13.0637 39.016 -13.1967 +7982 4 28.2142 15.8194 22.4189 7.40001 -5.36107 -10.8423 +7983 6 14.0621 9.56364 16.9937 6.86557 -12.9325 3.68967 +7984 4 14.7638 8.91135 17.1437 -0.397896 3.39204 -3.97785 +7985 4 14.5001 10.412 17.0773 -1.84745 7.98018 -3.95086 +7986 6 4.48418 30.1793 11.8502 16.4679 -16.8356 33.0547 +7987 4 4.88144 29.8061 12.6848 -7.18701 8.62616 -23.9784 +7988 4 3.54784 30.2411 12.0492 -7.30801 4.11375 -9.31782 +7989 6 40.8925 8.06286 23.6531 -5.33465 -0.617655 -7.49645 +7990 4 40.8929 8.28602 22.6923 5.67883 -10.477 13.1878 +7991 4 40.7177 7.10184 23.7416 4.86142 9.55736 -10.8624 +7992 6 53.7474 35.0502 16.7091 9.64852 13.8526 -34.5004 +7993 4 53.4511 35.8404 17.1588 -1.68768 2.98716 11.3576 +7994 4 54.0332 35.3898 15.821 -5.01984 -16.258 24.672 +7995 6 53.7089 10.1864 20.3635 2.29909 -3.91508 11.8946 +7996 4 53.865 9.95358 19.435 -6.30341 10.2468 0.803923 +7997 4 53.074 10.9174 20.4153 4.1525 1.61451 -13.3956 +7998 6 4.58325 27.0727 7.79253 38.2121 26.3993 -10.0836 +7999 4 5.27724 26.393 7.80253 -10.2172 -9.80276 1.23658 +8000 4 3.71677 26.7514 7.92113 -24.69 -25.9094 6.50141 +8001 6 50.5074 22.5408 22.1421 -8.69376 -16.3879 19.9073 +8002 4 50.2488 23.2402 22.7623 5.11604 2.17524 -13.9015 +8003 4 50.7961 22.8564 21.2903 3.5618 14.8025 -7.32432 +8004 6 7.04732 27.2027 21.6256 -40.8926 -21.8944 23.9514 +8005 4 6.7035 26.7027 22.422 28.3929 12.8045 -18.4773 +8006 4 6.19014 27.4064 21.2095 22.0893 5.82121 -6.88916 +8007 6 23.8331 35.0488 16.5891 16.32 14.4309 46.4508 +8008 4 24.6955 34.7392 16.9507 -15.4311 10.68 -10.0146 +8009 4 23.6772 34.608 15.7848 -0.180345 -20.5093 -35.2233 +8010 6 5.99568 23.9111 3.91414 -16.1284 -13.3557 2.33299 +8011 4 5.47632 24.0272 3.08057 3.14343 -7.41418 20.837 +8012 4 5.41258 23.5631 4.6401 5.53308 9.77645 -18.8553 +8013 6 38.7285 25.0725 19.1284 6.5843 12.292 11.4002 +8014 4 38.8305 24.3279 18.5317 -0.433768 -14.0645 -4.65001 +8015 4 38.9527 24.8378 20.0476 4.74577 -1.1864 -10.184 +8016 6 12.9754 18.2903 10.6176 0.588158 -4.74371 -11.7219 +8017 4 12.1189 18.2831 10.1754 -4.50324 1.27903 -1.36841 +8018 4 12.8026 18.5801 11.5112 2.24696 5.46905 14.7352 +8019 6 38.0467 41.2366 21.1082 -14.4892 -16.6352 -5.66336 +8020 4 37.1721 40.8226 21.1941 10.2151 -2.13153 3.70269 +8021 4 37.8745 0.133442 20.6393 0.730193 23.6843 -6.95691 +8022 6 6.9767 22.8602 17.8447 -15.6268 -18.8158 0.81989 +8023 4 7.5707 23.5707 17.6602 21.732 18.7089 -7.75629 +8024 4 7.31556 22.0497 17.428 2.05587 4.83625 4.35773 +8025 6 24.1095 19.3932 12.3316 12.1602 -2.11517 -13.1018 +8026 4 23.8745 19.734 13.1953 2.64822 12.0925 0.881714 +8027 4 23.8476 18.4865 12.3899 -10.6841 -23.2361 -5.46211 +8028 6 44.2232 28.4408 4.82746 -1.7669 2.66578 -25.5607 +8029 4 44.2803 28.1144 3.91045 1.22274 -3.80694 10.7546 +8030 4 44.1446 29.3994 4.68927 4.81937 -0.158515 8.55 +8031 6 23.3113 8.29915 21.4219 -9.51684 27.1403 7.66167 +8032 4 22.936 9.22921 21.4746 15.7805 -27.4461 5.90598 +8033 4 23.1012 8.0569 20.5135 3.89809 -6.65443 -0.402871 +8034 6 14.3464 2.18773 18.5362 -23.516 16.4481 4.67993 +8035 4 14.2678 1.24418 18.6898 10.1474 -10.2606 4.48578 +8036 4 15.2445 2.40605 18.3047 18.9771 -8.71598 -6.68368 +8037 6 28.0424 31.9381 34.1184 1.44373 -10.4149 10.0158 +8038 4 28.467 32.321 34.8914 3.92062 5.65333 3.09761 +8039 4 27.2701 32.5111 33.9835 5.51879 -6.95928 -12.9635 +8040 6 53.345 24.6925 18.2818 -10.4918 -25.9433 -31.7967 +8041 4 53.4866 24.6975 17.3285 -0.882305 -10.6531 -2.1422 +8042 4 53.7306 25.5021 18.5264 15.118 39.739 24.3772 +8043 6 36.8049 28.4285 22.9464 16.1639 5.31016 -1.79263 +8044 4 36.683 28.9472 23.7552 -13.3671 -7.69746 -0.238436 +8045 4 36.1639 27.7179 22.9267 -11.0056 -9.60672 10.1241 +8046 6 21.894 30.586 27.4834 -30.837 -7.47848 12.2714 +8047 4 22.1658 31.0121 28.3029 9.93408 7.2142 -4.82479 +8048 4 22.5499 30.6966 26.8178 23.3081 1.01511 -13.2982 +8049 6 10.2866 3.2829 27.2371 9.19947 -3.548 -7.92128 +8050 4 10.1566 2.73648 28.0281 -11.5907 7.20828 -5.58516 +8051 4 9.50383 3.79492 26.9844 -8.05462 -4.00143 11.7964 +8052 6 37.7145 25.01 29.7057 15.6828 -51.4836 -24.4954 +8053 4 38.34 24.5625 29.0621 -16.831 21.3675 19.2093 +8054 4 37.2613 24.2159 30.07 -2.41186 22.6264 5.87672 +8055 6 9.13271 24.4444 14.4751 26.0421 8.18538 46.692 +8056 4 9.10912 24.9781 13.7161 -5.31341 21.9098 -32.4591 +8057 4 8.68548 23.6494 14.2981 -19.3974 -37.2941 -14.6224 +8058 6 52.771 31.4727 7.38558 20.6973 -2.13415 1.08713 +8059 4 52.3061 32.183 6.93204 -2.34942 2.78723 -4.55897 +8060 4 52.1263 30.9997 7.89938 -16.8139 -9.70652 3.3966 +8061 6 21.3286 5.45224 36.4983 22.333 -40.4406 3.83692 +8062 4 20.7026 5.40277 37.2139 -7.55906 11.9598 8.05023 +8063 4 21.8475 4.61683 36.6516 -9.65069 29.8227 -15.0031 +8064 6 25.1743 37.2092 4.31919 7.23092 6.80805 -6.24923 +8065 4 25.4754 36.7175 3.5165 -8.68629 0.834167 19.7743 +8066 4 24.8491 36.6197 5.01948 2.53349 -5.19005 -7.77823 +8067 6 34.0165 17.4759 18.2358 -58.4306 -31.0723 45.6386 +8068 4 34.1944 16.9598 19.0779 8.50138 15.1756 -22.5601 +8069 4 33.0528 17.7413 18.4058 39.5305 3.9888 -12.396 +8070 6 37.9578 37.5059 25.2944 -35.6234 -15.4362 -10.7836 +8071 4 36.9622 37.6721 25.197 38.0574 -5.35834 -1.14338 +8072 4 38.1643 36.7565 24.689 -7.79603 13.8086 8.25116 +8073 6 5.07735 4.86484 15.8417 42.9381 3.72816 7.10952 +8074 4 5.88838 4.293 15.9163 -33.8081 0.492332 -6.16483 +8075 4 5.50277 5.71956 15.9997 -16.006 -0.473971 1.61617 +8076 6 14.1507 7.19336 7.76886 38.052 -10.4208 -22.4486 +8077 4 13.5129 7.55624 8.34295 -29.9694 15.266 25.1048 +8078 4 13.7195 6.96448 6.9333 -0.98027 3.69224 9.82406 +8079 6 24.98 10.8641 38.0829 22.9212 14.7137 56.6455 +8080 4 25.3157 11.7906 38.09 -5.76353 -21.6486 -14.5596 +8081 4 24.5861 10.6473 37.2742 -21.4949 -6.61803 -48.2716 +8082 6 35.683 7.97762 22.8121 -8.7657 -2.24292 -6.28447 +8083 4 36.2591 8.71308 23.0369 7.49089 3.45465 4.10549 +8084 4 35.4159 8.13228 21.894 -1.16553 2.61323 2.89561 +8085 6 24.8067 29.1485 22.4175 -2.13284 -11.1741 5.39142 +8086 4 24.8847 28.3567 22.9764 5.78872 7.02228 0.265808 +8087 4 23.868 29.1687 22.2304 -8.38579 3.51829 -7.32943 +8088 6 38.496 31.6463 38.4547 5.18571 -7.52333 -11.192 +8089 4 38.5561 32.3892 37.8222 0.442926 -5.96945 11.3455 +8090 4 38.4779 31.9675 39.3579 -6.04594 15.0172 8.52038 +8091 6 7.23911 33.2316 15.4021 21.919 9.41665 12.382 +8092 4 8.12833 33.2899 15.8377 -30.0201 5.59214 -9.80336 +8093 4 7.41373 32.5516 14.7298 -12.8129 5.82399 11.4308 +8094 6 43.353 23.6104 1.44592 7.44142 11.305 12.851 +8095 4 43.1845 24.4377 0.974361 -3.6145 -11.1369 -5.61195 +8096 4 44.1543 23.8467 1.95013 -11.1925 -12.9992 -13.6036 +8097 6 3.53991 32.9016 14.8697 -2.39625 2.76445 6.29056 +8098 4 3.69073 33.2429 13.9877 -3.53656 0.018747 -12.9915 +8099 4 3.78624 33.6349 15.4383 2.83762 5.11564 5.16825 +8100 6 25.3096 21.77 8.26163 -6.66296 0.990367 -4.9072 +8101 4 26.025 21.1206 8.24337 -4.14835 5.1806 10.2199 +8102 4 24.7855 21.68 9.08833 13.2195 -2.77387 -11.0894 +8103 6 43.8224 15.3683 17.7688 -17.5044 -13.9077 -11.4765 +8104 4 43.5422 15.0425 16.8907 -4.65964 7.2866 4.53357 +8105 4 44.7684 15.2434 17.7192 12.2011 1.97977 1.51727 +8106 6 15.7838 16.2525 16.6573 54.0838 12.7989 52.3812 +8107 4 16.4697 16.8261 16.2793 -6.54184 -0.771336 -3.5329 +8108 4 15.1467 16.1661 16.0105 -48.6612 -2.23154 -48.9531 +8109 6 31.9022 12.8519 11.5241 2.75902 49.2592 5.12049 +8110 4 32.4395 13.2725 12.2474 -7.6131 -20.2803 -12.0836 +8111 4 31.5562 13.6461 11.0457 0.0384164 -26.7823 6.27126 +8112 6 18.2248 5.33623 10.1812 -15.488 18.8418 -23.6702 +8113 4 17.7687 5.75894 9.42369 15.7694 -11.8332 4.62439 +8114 4 17.5271 5.29555 10.8288 -1.36455 -9.23689 12.3446 +8115 6 23.0917 39.0779 10.9282 -11.4905 7.21092 -0.352408 +8116 4 23.963 38.6888 10.8472 1.7552 7.95734 1.65941 +8117 4 23.1114 39.9529 10.5005 0.666922 -10.0515 1.633 +8118 6 46.8677 33.7562 8.76248 1.03354 -2.05441 8.38343 +8119 4 46.5037 34.5328 8.27588 2.5022 -8.853 20.9954 +8120 4 47.1475 33.9422 9.6931 -6.44786 13.1686 -22.3696 +8121 6 31.243 39.9317 20.2224 2.33635 -7.70313 -8.05101 +8122 4 30.8704 39.2996 19.5871 0.699046 7.37293 6.91414 +8123 4 32.2017 39.8574 20.0757 -3.27099 6.09826 0.0696837 +8124 6 15.889 33.0919 19.7864 33.8788 -7.40125 -13.3883 +8125 4 16.1628 33.8221 19.1895 -10.4151 -15.5823 0.760964 +8126 4 16.5176 32.3427 19.5839 -16.9866 18.4919 10.6578 +8127 6 32.5555 39.9164 2.66523 30.0039 -10.6491 -2.95451 +8128 4 33.3508 39.5896 3.12591 -10.8726 3.49711 -8.16538 +8129 4 32.1027 40.3655 3.36837 -16.5932 8.39248 6.84073 +8130 6 50.6959 12.1983 3.90519 17.0412 -18.9771 -24.2847 +8131 4 51.4658 12.4814 3.40053 -2.43524 -2.94964 -4.56419 +8132 4 50.632 12.8314 4.58319 -9.04718 30.5099 32.8795 +8133 6 44.7022 2.76366 12.1205 -8.84849 12.6495 8.41904 +8134 4 44.8494 1.8734 11.8267 15.0216 -15.1797 -4.64519 +8135 4 44.7278 2.73137 13.1008 3.87902 2.35132 -20.2006 +8136 6 11.5141 11.9335 31.6448 -3.41939 3.48047 19.9552 +8137 4 11.2577 12.7405 32.1375 2.53248 -5.05318 0.0588515 +8138 4 11.4496 11.2091 32.2982 6.40928 8.91696 -7.15415 +8139 6 4.75269 10.0418 10.4949 -1.19321 15.9867 3.21309 +8140 4 5.0001 10.2283 11.4058 3.15466 -0.54389 -0.234941 +8141 4 4.46559 10.9018 10.1184 3.18705 -14.0527 1.96128 +8142 6 17.0994 25.0099 20.58 37.5195 36.994 -31.4742 +8143 4 16.2483 24.8536 20.9144 -42.3557 -15.7488 8.6923 +8144 4 16.9647 25.6792 19.8535 4.26961 -24.361 15.5384 +8145 6 48.1092 4.75471 14.8037 19.9531 12.9172 -19.4869 +8146 4 47.21 5.0173 14.8371 -33.3483 -4.43172 15.4156 +8147 4 48.388 5.38041 14.11 12.4129 -13.382 8.75366 +8148 6 18.8523 3.11742 3.41631 -21.2483 -3.07087 -4.7476 +8149 4 18.4665 2.24821 3.59937 1.50537 0.955968 2.27262 +8150 4 19.7704 2.98892 3.60058 26.8928 -3.50499 2.30699 +8151 6 35.4247 26.4577 29.0527 -22.8013 -8.66021 5.68805 +8152 4 35.5248 27.2067 28.475 -2.85698 13.778 -9.76065 +8153 4 36.2768 26.0489 29.0602 21.3259 -10.4415 3.203 +8154 6 32.3896 31.2185 12.8503 57.1958 12.7231 -6.23232 +8155 4 31.5925 31.2509 13.3022 -48.7441 2.01486 27.8379 +8156 4 32.2029 30.8426 12.0127 -5.8383 -14.614 -31.3947 +8157 6 33.0076 28.3366 37.5983 -27.3824 -5.67666 30.0102 +8158 4 32.1052 27.9852 37.8568 28.4022 2.55731 -9.07316 +8159 4 33.3988 28.5694 38.4733 -3.969 -4.9759 -22.0899 +8160 6 45.5072 24.7908 10.3169 -45.8214 60.3209 -7.47747 +8161 4 44.9002 25.317 9.70444 28.5781 -13.9385 29.3176 +8162 4 45.5876 23.9971 9.85482 14.9117 -49.3191 -19.3714 +8163 6 14.779 31.7044 3.16918 -45.5594 -6.97168 29.5477 +8164 4 14.0337 32.2859 2.90387 21.9125 -3.3602 -3.07131 +8165 4 14.4311 31.26 3.996 20.2164 14.1486 -26.6391 +8166 6 31.9242 7.68885 4.30286 23.54 -20.9123 31.4536 +8167 4 31.4705 6.84633 4.17995 2.0164 -2.82895 4.59018 +8168 4 31.5931 8.24323 3.64247 -18.259 33.7262 -37.7068 +8169 6 42.5699 17.3136 32.1968 24.1944 7.3606 3.32713 +8170 4 41.6254 17.2329 32.2603 -19.9776 4.79877 -7.53323 +8171 4 42.7917 18.2007 31.8224 -10.4585 -19.5065 0.0265862 +8172 6 13.8071 23.1746 23.5515 16.4347 -15.6283 -2.15259 +8173 4 13.5183 23.7639 24.245 0.233797 9.11225 10.6616 +8174 4 14.6093 22.7029 23.9066 -20.7684 16.5326 -5.05411 +8175 6 10.7126 7.09833 3.97095 14.1471 -33.6721 -68.9477 +8176 4 10.4245 6.93934 4.82914 -14.4566 -0.97954 55.1879 +8177 4 10.4869 6.2311 3.50145 10.3151 35.4271 10.8748 +8178 6 28.7967 8.6797 17.9015 -30.1103 -2.72244 -33.0478 +8179 4 29.5795 8.35746 17.4579 9.90558 -6.78874 -8.85398 +8180 4 28.1705 8.90161 17.1378 19.1156 -3.64084 26.8114 +8181 6 19.4515 29.3423 26.6295 -39.4767 12.5835 42.7579 +8182 4 19.0038 29.6555 27.482 17.5864 -10.0531 -35.2193 +8183 4 20.2946 29.7741 26.6551 17.8114 4.03003 1.9258 +8184 6 40.6571 40.9865 14.5722 30.7749 0.116883 17.4953 +8185 4 40.9453 41.7159 14.038 -4.90719 13.3855 -18.4876 +8186 4 41.4974 40.7167 14.9881 -11.2006 -4.47055 2.16552 +8187 6 46.2595 14.0857 31.7293 11.6035 -9.35965 4.24636 +8188 4 46.4659 13.1386 31.6985 -1.25294 5.8657 1.71226 +8189 4 45.5092 14.1916 31.1613 -13.5258 4.10617 -10.238 +8190 6 36.7111 36.3198 8.38634 20.5175 24.5507 44.7988 +8191 4 36.5848 37.248 8.66174 -25.6048 -20.3538 -28.8485 +8192 4 37.4262 36.1922 9.03978 -4.76011 -28.7723 -18.9481 +8193 6 30.7791 32.4382 38.0814 8.60258 1.74334 21.9396 +8194 4 31.3949 31.9394 37.5795 9.21482 -20.9838 -26.5205 +8195 4 31.4122 32.9586 38.5821 -11.3785 16.1645 3.6603 +8196 6 47.8794 8.8384 10.1746 26.299 41.1069 27.7005 +8197 4 47.2075 9.11907 9.56312 -13.0744 -2.84885 -16.672 +8198 4 48.1152 7.93695 10.1106 -1.40956 -33.8723 -12.987 +8199 6 24.4191 17.0005 30.9872 -11.3759 2.04439 -13.9008 +8200 4 23.6647 16.9339 30.3566 16.9629 0.0568796 9.7226 +8201 4 24.0218 17.1528 31.8579 2.94571 -1.21426 -7.57694 +8202 6 40.5018 5.09847 4.47991 -26.6992 -20.3188 -5.14046 +8203 4 41.28 5.65048 4.47318 14.3705 11.228 -11.5737 +8204 4 40.0798 5.05838 3.58104 19.0568 4.03597 15.916 +8205 6 52.5742 28.0973 6.9077 -25.4379 -29.0344 16.6943 +8206 4 52.3933 28.6001 6.11132 1.2128 1.19853 -1.81518 +8207 4 51.7383 27.5823 7.10916 28.4347 22.908 -9.38917 +8208 6 36.064 32.3866 23.6124 7.53581 -25.1682 -6.10704 +8209 4 36.4508 32.2046 22.7426 1.48893 5.77393 9.47334 +8210 4 35.7934 33.2936 23.5958 -9.41601 17.7382 0.925908 +8211 6 23.6488 31.8764 22.7665 2.85736 4.06253 -9.33391 +8212 4 23.7634 32.5358 22.0878 -9.04528 15.3932 -0.43099 +8213 4 24.3599 31.3007 22.5126 8.23075 -21.5035 13.0322 +8214 6 0.735457 24.4657 41.7131 -9.37188 -1.3071 -20.2528 +8215 4 1.20497 24.8068 40.9273 -3.735 -3.01915 11.177 +8216 4 54.8235 24.2347 41.4089 15.688 5.53844 3.35783 +8217 6 15.9771 8.98022 19.8191 22.6241 -28.8974 20.594 +8218 4 15.5109 8.26292 19.4118 -7.13343 -10.7615 -13.7959 +8219 4 15.6388 9.77471 19.4696 -19.2292 39.8019 -15.8774 +8220 6 33.1716 12.5629 20.0326 13.9441 -12.6476 -4.49459 +8221 4 32.9044 11.6183 19.8429 16.5289 30.3248 6.35834 +8222 4 34.162 12.7185 19.975 -34.5589 -12.2038 -12.3621 +8223 6 7.03971 24.945 26.3683 -0.33354 -9.69316 23.9049 +8224 4 6.80945 24.3756 27.1101 -9.22275 -9.46444 -2.85995 +8225 4 7.84656 25.3251 26.6963 17.391 9.90995 -3.06061 +8226 6 44.4739 22.5508 36.9255 -16.7075 -6.88118 10.4755 +8227 4 43.5027 22.4108 36.9334 15.1456 1.07948 9.67769 +8228 4 44.6732 22.7799 36.0336 3.04889 5.98288 -21.3947 +8229 6 39.2775 23.7142 25.1185 -44.4168 -97.0378 5.9092 +8230 4 39.6033 24.5307 24.937 33.9242 88.3913 -14.6991 +8231 4 38.7559 23.4597 24.3323 8.03463 3.9453 13.1815 +8232 6 20.3756 2.20712 36.9897 -7.56257 -5.27652 1.95266 +8233 4 20.2168 1.45659 37.5665 4.06747 -3.41627 8.94019 +8234 4 20.2802 1.85339 36.1124 5.28277 1.38 -10.8685 +8235 6 22.8571 19.5527 3.6659 6.2145 7.79245 45.4341 +8236 4 22.8782 19.7834 4.64919 -10.5004 -5.13291 -37.3231 +8237 4 23.7426 19.8021 3.38476 9.02488 -3.84737 -6.15569 +8238 6 31.6989 12.5719 34.5929 20.3571 12.3337 69.8717 +8239 4 31.0774 13.2339 35.0297 17.9304 -15.3013 -22.977 +8240 4 32.3378 12.3324 35.3667 -30.4994 7.85147 -45.3393 +8241 6 12.9846 10.2214 25.1019 -30.6317 10.0697 -32.3453 +8242 4 13.6677 9.95937 25.6652 38.8731 -4.05338 37.0168 +8243 4 12.5116 9.4018 25.0264 -11.673 -9.01961 -8.06086 +8244 6 27.2702 0.587979 13.2088 -29.2359 -8.68669 8.17042 +8245 4 27.7024 41.6312 13.2942 -2.56798 3.03598 -7.56301 +8246 4 26.2795 0.464606 13.259 26.6373 -0.778522 -5.81594 +8247 6 5.6575 24.9337 13.9905 13.1991 2.90197 -9.87868 +8248 4 4.70598 24.9553 13.883 -5.9976 0.782062 8.57209 +8249 4 5.90972 25.4072 14.7914 -9.20077 -1.59682 1.38283 +8250 6 22.9799 17.9518 0.527007 -12.0607 -30.0717 13.8125 +8251 4 22.428 18.6392 0.176667 -3.67819 14.6501 -9.17369 +8252 4 22.2816 17.3415 0.914453 31.709 16.1034 -10.9012 +8253 6 33.0985 25.4181 5.46205 -15.7978 -31.0624 1.20161 +8254 4 33.3789 26.3039 5.55078 15.9502 30.9866 -6.27287 +8255 4 32.9645 25.2082 4.52957 3.04969 3.7853 3.27689 +8256 6 8.52872 7.94688 17.4833 18.4257 15.9711 -24.7978 +8257 4 9.39098 8.3855 17.3119 -11.8135 -8.35054 -2.98105 +8258 4 8.4858 7.94817 18.4262 -6.55829 -2.0729 23.5191 +8259 6 26.8237 0.686378 2.88748 4.07 30.2002 2.01549 +8260 4 26.8412 0.391628 3.80568 -3.86709 0.733005 8.35451 +8261 4 26.5975 1.66265 2.91719 8.86873 -29.5911 -1.41132 +8262 6 50.0397 34.7157 15.6267 -11.8175 -1.09292 -1.87233 +8263 4 50.6372 35.2521 15.0721 -14.1207 -5.91477 -4.02646 +8264 4 49.1323 34.6374 15.219 24.748 6.82197 2.94942 +8265 6 46.275 5.00035 11.1282 9.7079 18.7279 -10.06 +8266 4 45.8191 4.20733 11.3912 -11.1099 -14.8598 8.88229 +8267 4 46.9633 4.71614 10.5231 1.70636 -6.51939 -1.67277 +8268 6 33.7833 38.63 35.3851 22.6491 -26.5736 53.3982 +8269 4 34.0604 38.9625 36.3013 -14.2885 -2.00103 -44.5517 +8270 4 33.6201 39.3455 34.786 -2.63152 22.0909 -4.2817 +8271 6 30.8201 25.8435 41.2101 0.522631 -30.718 -12.9218 +8272 4 31.0968 24.9266 41.4082 -1.05643 6.85883 -6.1679 +8273 4 31.1715 26.3436 0.016995 6.66556 20.3816 22.2796 +8274 6 50.2276 0.978128 24.4598 74.6558 22.0158 36.8282 +8275 4 49.5306 0.534407 24.0585 -38.5843 -30.8873 -31.929 +8276 4 51.1134 0.532188 24.3239 -37.6779 9.32343 -0.630533 +8277 6 31.2996 0.720873 19.0302 14.3507 40.5737 -10.6901 +8278 4 30.4605 0.743437 18.5837 -16.9464 -9.10756 -3.3833 +8279 4 31.3343 41.8987 19.5933 -6.31648 -47.867 22.0648 +8280 6 39.0778 29.5479 19.1423 -24.9794 -6.4558 -1.7207 +8281 4 38.1293 29.5816 19.4551 33.1986 -8.08964 -3.40762 +8282 4 39.446 28.6506 19.2986 -6.02354 14.8003 0.990496 +8283 6 21.659 17.5991 25.8953 -11.5386 33.2832 -7.33353 +8284 4 22.0418 18.5204 25.967 -8.02723 -30.5851 6.12101 +8285 4 20.778 17.7492 25.4824 18.7799 -9.30112 4.66445 +8286 6 35.0777 28.803 27.4254 -1.70316 -21.0069 37.4458 +8287 4 35.3301 29.4791 28.0775 3.3924 -2.39002 -8.5847 +8288 4 35.0935 29.2141 26.5843 6.79083 21.8236 -32.9604 +8289 6 30.7137 25.4449 11.6588 -11.4017 25.922 39.321 +8290 4 30.5753 25.9017 12.5616 8.60864 -26.5127 -36.0552 +8291 4 30.5331 26.1452 11.022 4.69716 -0.666916 0.479504 +8292 6 7.33812 15.1344 12.3538 4.68116 -40.544 31.6975 +8293 4 6.75693 14.3594 12.209 2.06777 16.361 -3.14284 +8294 4 7.31295 15.622 11.5607 -9.0052 27.071 -31.8075 +8295 6 16.8334 26.8188 7.04972 -25.5936 3.66279 -30.8653 +8296 4 17.5758 26.708 7.59816 38.4339 -11.2263 23.8467 +8297 4 17.1819 26.9966 6.1597 -5.58153 -2.73835 6.66814 +8298 6 29.5302 33.0784 31.0001 -37.3865 -15.0005 -19.6245 +8299 4 28.6433 32.7554 30.7459 2.04647 15.9344 -4.27919 +8300 4 29.8764 32.2746 31.3613 18.5632 -10.7791 20.7082 +8301 6 14.1048 2.11879 30.9099 -3.69766 -14.7615 43.6071 +8302 4 14.1458 1.95878 31.9138 -8.46722 9.63961 -39.7078 +8303 4 13.6642 1.31591 30.5661 9.09938 8.95306 -0.112961 +8304 6 15.6571 22.2632 2.89617 -37.5764 43.5932 -9.62192 +8305 4 16.4348 21.7941 3.05118 39.5293 -34.0009 4.7875 +8306 4 15.0286 21.6897 2.4522 -3.10464 -12.538 6.06705 +8307 6 23.7259 29.1153 40.9645 17.3396 38.8389 1.6287 +8308 4 23.2818 30.0193 40.9831 11.4767 -32.1544 -0.906545 +8309 4 24.7087 29.2887 40.9216 -25.4222 -7.32646 2.20707 +8310 6 38.1247 14.1642 13.7107 12.8592 31.0763 6.54808 +8311 4 37.6278 13.3808 13.8383 -17.8092 -31.0521 2.1891 +8312 4 38.9029 13.9224 13.2095 7.41852 -3.42228 -8.90759 +8313 6 35.2503 26.5068 15.521 -3.09354 13.3371 19.8917 +8314 4 34.5349 26.5126 14.8818 -0.932758 -4.81772 -4.34805 +8315 4 34.9075 27.0382 16.2823 10.0491 -13.0104 -19.4153 +8316 6 19.0968 34.7379 16.486 5.71756 23.995 22.7437 +8317 4 19.4075 35.6523 16.3704 4.72819 -11.1284 17.3551 +8318 4 19.0401 34.4508 15.6072 -6.41662 -20.6903 -39.0731 +8319 6 18.1723 29.7514 35.7083 20.6671 12.6318 -10.71 +8320 4 18.3041 30.5743 35.1773 -7.60682 -14.8418 20.474 +8321 4 19.0351 29.5718 36.145 -10.3356 2.9076 -6.19235 +8322 6 54.1213 22.2675 24.9131 12.7342 -33.1199 -26.8219 +8323 4 53.6265 21.7967 24.1967 9.15099 10.4438 12.7736 +8324 4 53.5183 22.8995 25.2476 -23.1208 24.5105 7.38222 +8325 6 30.3446 10.3415 34.0026 7.84994 -0.761596 -9.91104 +8326 4 29.5868 10.4349 34.5739 -14.9697 1.07498 11.7851 +8327 4 30.8511 11.1643 34.0933 -4.52293 -3.62201 3.70872 +8328 6 38.3178 33.8965 18.5989 -35.8058 -11.4104 -3.76591 +8329 4 38.923 33.166 18.7063 19.7544 -4.29321 9.06839 +8330 4 38.8137 34.6503 18.3352 23.7539 21.4454 3.52643 +8331 6 22.4873 14.1653 34.4312 -21.9658 -17.0918 -49.1801 +8332 4 22.5571 13.4626 33.7145 -4.81718 29.7264 22.473 +8333 4 23.0772 13.8965 35.1058 26.7449 -1.29975 22.8703 +8334 6 38.021 0.617904 2.36461 -2.26574 -7.91048 -40.4777 +8335 4 37.6239 1.19646 3.0125 3.99393 1.59858 23.4614 +8336 4 38.7851 0.132723 2.71367 -6.22024 4.30596 13.4956 +8337 6 38.885 41.133 10.292 38.4397 69.693 -20.9517 +8338 4 38.7327 0.223589 10.3334 0.502898 -40.1285 -2.38265 +8339 4 38.1678 40.7662 10.7395 -40.074 -22.1176 34.0334 +8340 6 53.417 21.9266 38.962 18.4876 1.53578 17.2983 +8341 4 52.9974 21.8755 38.1026 3.71535 5.74942 -10.4205 +8342 4 54.37 22.1639 38.7939 -25.8904 -11.793 -3.59034 +8343 6 39.9933 12.7125 36.2959 -18.8272 27.1562 12.2819 +8344 4 39.0734 12.4542 36.2547 -7.90274 -1.75871 9.35878 +8345 4 40.3901 12.0873 35.7283 26.8007 -18.4843 -23.2317 +8346 6 48.44 17.2431 40.5981 -19.9836 6.93831 4.04917 +8347 4 47.6199 17.7956 40.4399 22.5854 -23.5642 7.97707 +8348 4 48.3147 16.8142 41.4747 5.07747 10.2388 -9.33604 +8349 6 32.0284 9.3439 40.0151 10.5149 -12.1651 13.6504 +8350 4 32.8546 9.41316 39.523 -1.99935 -3.17675 -6.39298 +8351 4 31.9706 8.39334 40.2816 -10.0936 21.7982 -4.27543 +8352 6 31.75 22.4929 6.3685 -34.2181 3.54143 23.53 +8353 4 31.3779 21.709 6.82557 12.2201 6.35834 -11.7559 +8354 4 31.3059 23.2194 6.8777 16.0591 -13.7554 -15.3432 +8355 6 51.0144 2.58529 21.579 28.4772 -3.64411 10.4611 +8356 4 51.4343 1.72703 21.8198 -11.0001 9.38403 -4.71992 +8357 4 51.7571 3.20177 21.4507 -11.3685 -6.83795 2.38662 +8358 6 13.6247 22.0465 12.1442 29.0901 0.46256 9.76546 +8359 4 14.4578 22.3795 12.5465 -13.9989 1.27328 -8.95219 +8360 4 12.915 22.6494 12.3833 -3.04453 8.5056 -1.94564 +8361 6 23.6209 24.0381 14.6453 -17.5202 11.834 -36.5316 +8362 4 24.2009 24.4886 15.2598 9.8869 4.60732 -3.70937 +8363 4 23.5497 24.6116 13.8304 3.00595 -20.2815 30.972 +8364 6 9.32136 4.85156 31.2387 8.97842 0.466865 -3.67014 +8365 4 8.41764 4.8259 30.9291 -8.7496 -0.132795 -7.84821 +8366 4 9.23666 5.38964 32.029 2.44443 -3.9247 9.21777 +8367 6 16.6769 26.3146 18.0426 -28.7898 -24.0576 -1.25383 +8368 4 15.7763 26.5978 17.7405 22.2361 3.17889 2.46191 +8369 4 17.2688 27.0532 17.9767 7.52301 23.5471 -7.71583 +8370 6 5.12002 13.5179 11.5454 -28.2867 15.553 -42.5279 +8371 4 4.34318 13.4159 12.0982 -3.89331 -5.54815 13.62 +8372 4 4.69334 13.8537 10.6805 23.3071 -7.58808 40.5266 +8373 6 29.613 23.6535 8.07622 4.06305 -5.39054 -18.0309 +8374 4 29.2087 23.3655 8.89798 -2.48969 6.78204 1.65997 +8375 4 29.356 24.5861 7.97247 8.33853 -10.6544 5.22118 +8376 6 0.809058 7.56442 27.8431 6.90575 4.16885 -14.0934 +8377 4 0.916059 7.33161 28.7668 -1.2645 -7.40385 9.39857 +8378 4 1.47033 8.27499 27.7095 -9.19662 -21.8408 -1.77541 +8379 6 15.4183 9.78145 0.490529 10.0725 -7.13925 0.979932 +8380 4 16.087 9.43012 41.8027 -0.259761 -4.12548 -6.98761 +8381 4 15.4693 9.20893 1.26423 -1.27146 5.63374 6.96511 +8382 6 18.8191 0.059487 34.1187 -25.6574 -0.396319 -31.4644 +8383 4 18.4098 41.5755 33.3103 16.2128 4.97009 18.3796 +8384 4 18.5054 0.975155 34.0945 0.533414 5.37151 1.64989 +8385 6 18.7349 30.7803 29.1665 47.4813 -67.7405 25.7886 +8386 4 19.5534 30.6866 29.7899 -42.3671 12.2249 -32.0712 +8387 4 18.5184 31.6699 29.0545 -8.91834 48.7901 3.3651 +8388 6 48.4474 16.4903 36.136 -4.39653 9.55775 -4.4164 +8389 4 47.5651 16.9082 36.2181 15.0357 -0.381514 0.207393 +8390 4 48.471 16.1274 35.2331 3.08724 1.10756 7.15907 +8391 6 43.7979 0.472205 29.2706 42.555 -4.96452 -15.1149 +8392 4 42.8863 0.267919 29.38 -32.9664 -6.64218 10.9475 +8393 4 44.2792 41.5357 29.3524 -8.26894 11.2804 8.78801 +8394 6 16.7205 13.887 21.3769 2.19577 2.66609 -2.49996 +8395 4 16.2052 14.7022 21.5336 6.85381 -11.1318 0.719729 +8396 4 16.6911 13.4037 22.2072 -6.06459 1.50462 5.19021 +8397 6 17.3883 13.4356 26.2524 27.4966 3.2637 -26.6685 +8398 4 18.1303 13.5822 25.5825 -26.8694 -2.13737 32.6247 +8399 4 17.6394 12.6216 26.7148 -3.51452 -0.718268 0.201186 +8400 6 48.1557 10.2329 23.6958 7.66187 -11.6345 21.9365 +8401 4 48.0869 10.5828 24.5972 -4.20109 -8.3855 -4.21906 +8402 4 47.9242 10.9774 23.1563 3.12678 5.33996 -12.4543 +8403 6 28.2651 17.9126 17.8865 15.704 23.8601 -19.8805 +8404 4 29.0328 18.4581 17.6288 -8.16305 -6.08358 1.86534 +8405 4 28.6272 17.0995 18.2183 0.672722 -20.799 10.0784 +8406 6 54.0866 38.1772 23.6885 15.2416 -7.03948 -9.32302 +8407 4 0.015845 37.9236 23.4759 -13.1891 10.5947 7.1207 +8408 4 53.5403 37.6177 23.1226 -4.14834 -2.69562 5.50015 +8409 6 8.47885 18.3973 11.4073 -18.4373 -13.8141 42.9629 +8410 4 7.63335 18.6519 11.0416 -6.40415 6.02722 -6.48684 +8411 4 9.12927 18.583 10.7796 32.3175 8.52747 -41.6205 +8412 6 45.9451 12.8796 11.0371 -17.0736 -2.86831 -37.3051 +8413 4 46.6905 12.613 10.4807 4.61659 2.073 6.35499 +8414 4 45.2044 12.775 10.3831 8.06265 2.44535 24.075 +8415 6 16.2127 8.79404 14.0297 41.7324 -66.6139 22.361 +8416 4 15.4739 9.28873 13.8367 -45.7772 50.9633 -18.0772 +8417 4 17.0286 9.27652 14.012 9.93977 26.888 -8.08533 +8418 6 42.7214 13.3612 21.3881 16.6788 44.7105 -2.77317 +8419 4 41.8036 13.1589 21.3301 -20.1042 -28.5105 -1.62877 +8420 4 42.6833 14.2978 21.1276 5.52546 -8.26362 1.62797 +8421 6 21.0018 40.4256 16.4674 21.2457 -19.0828 1.73859 +8422 4 20.7372 40.049 17.3276 2.67731 3.65462 -7.46566 +8423 4 21.8606 39.9985 16.1939 -29.0987 10.293 9.55187 +8424 6 45.6337 11.4313 32.9356 51.1157 -40.0447 2.01383 +8425 4 46.3303 10.7696 33.2563 -29.172 28.0234 -20.2541 +8426 4 45.1866 11.676 33.7277 -20.3741 9.53259 21.5498 +8427 6 26.9484 8.87146 24.2965 48.4346 1.85391 18.4292 +8428 4 27.5311 9.68141 24.3337 -29.9021 -15.2605 -8.39328 +8429 4 27.4823 8.26118 24.8676 -16.4416 6.67878 -12.0087 +8430 6 18.977 2.43413 29.3663 0.758316 16.52 -7.40381 +8431 4 18.1944 2.4248 29.9271 -0.767207 -2.12047 7.99903 +8432 4 19.1173 3.36872 29.101 -3.03797 -9.07666 7.57415 +8433 6 8.2454 29.1679 19.723 -8.63488 -12.9151 21.1286 +8434 4 8.14448 28.8871 20.6627 3.14293 7.67545 -21.2948 +8435 4 7.83715 28.464 19.1969 -1.03495 3.62674 2.54809 +8436 6 9.03976 34.3129 18.6533 -7.54593 -6.72093 -3.09965 +8437 4 8.77081 34.2931 19.577 -0.177883 2.97642 -7.59668 +8438 4 9.06659 35.2455 18.4187 6.50563 1.62734 -4.46359 +8439 6 10.1892 11.9266 11.2355 -21.5107 11.0325 -1.739 +8440 4 10.2333 12.874 11.065 17.4692 -2.43612 -1.88546 +8441 4 9.23632 11.7983 11.121 5.09535 -6.80078 4.24402 +8442 6 35.7546 21.6858 36.1669 -23.2352 21.9394 0.834429 +8443 4 35.0265 22.3595 36.1433 18.2091 -18.4066 2.26802 +8444 4 36.3924 22.0173 36.8321 -9.99636 -6.87572 -9.75527 +8445 6 17.0812 12.5048 36.3903 -12.1142 25.6516 12.5185 +8446 4 17.3175 12.8308 37.2812 -0.49448 -9.18651 -10.1264 +8447 4 17.5662 11.7075 36.2155 7.76979 -20.5663 -1.07791 +8448 6 37.1566 13.0227 34.2843 -17.9764 -6.1284 -55.2853 +8449 4 36.5549 12.2662 34.3472 4.68366 1.60167 -17.3784 +8450 4 37.3932 13.1268 35.1567 14.9075 13.7384 64.605 +8451 6 38.9862 29.5501 13.2301 -1.89389 21.6683 -7.70005 +8452 4 38.7944 28.7085 12.8419 -2.19861 -17.9948 -10.7911 +8453 4 38.6501 29.4932 14.1174 1.27468 3.77518 16.782 +8454 6 0.176516 29.3495 29.4845 -12.5141 10.2637 -5.31555 +8455 4 0.737394 28.6151 29.2028 3.82179 3.49987 -8.15609 +8456 4 54.9814 29.9211 28.6995 5.57042 -17.7863 13.6106 +8457 6 15.9458 0.256833 12.7596 -44.0073 4.56069 2.48191 +8458 4 15.316 0.578271 12.0799 19.6091 -0.692249 -3.06606 +8459 4 15.3039 41.7798 13.3939 19.5978 -0.7471 3.56907 +8460 6 3.99127 11.9482 8.78851 -15.4327 -39.7622 32.4444 +8461 4 4.35413 11.6179 7.97869 6.27746 3.41828 -23.4587 +8462 4 3.98972 12.8788 8.75552 1.02746 43.1268 -6.73396 +8463 6 24.041 23.6822 19.9783 33.1595 11.366 0.122861 +8464 4 23.6132 22.8866 19.7159 -20.0299 -17.1205 -2.84168 +8465 4 23.4218 24.2757 20.3917 -9.46777 4.2557 4.80954 +8466 6 4.48057 2.29323 23.9805 -22.9759 10.1361 69.4322 +8467 4 4.73792 2.40802 23.1034 3.49419 10.2026 -52.1527 +8468 4 3.69711 2.85929 24.1902 11.7092 -10.5693 -13.4065 +8469 6 33.0966 27.663 33.8386 -28.073 -12.9468 -7.71443 +8470 4 33.3687 28.5694 33.7309 6.85765 13.8135 -2.76136 +8471 4 33.7449 27.1385 34.2981 13.436 1.78162 12.2729 +8472 6 11.3912 21.7129 6.08719 -17.5666 -2.19741 -2.39462 +8473 4 12.3323 21.6847 6.05692 28.5529 -3.65784 2.285 +8474 4 11.1694 22.1681 5.26899 -4.22105 -2.6604 -2.39966 +8475 6 37.2225 13.5364 23.6261 -18.6729 23.2035 4.88571 +8476 4 37.3138 14.0862 24.4412 -7.0733 -14.7121 -13.3014 +8477 4 37.9734 12.9786 23.5155 30.7338 -8.31921 -1.90296 +8478 6 5.00503 21.0366 33.3647 1.8453 38.5327 -33.3657 +8479 4 4.21257 21.4237 32.9267 15.1329 -13.9269 -2.57683 +8480 4 4.69097 20.5075 34.0602 -12.1996 -25.3348 31.8286 +8481 6 18.1998 37.5792 26.9379 10.6598 2.97497 -14.5277 +8482 4 17.7896 38.4267 27.1371 3.99806 -1.69574 -0.528064 +8483 4 18.8493 37.7746 26.2284 -6.0853 -8.42077 12.5802 +8484 6 19.7447 16.1537 4.6847 3.25094 -1.99961 -5.02271 +8485 4 18.927 15.8729 5.11398 3.02189 5.09699 3.93014 +8486 4 20.4865 15.8366 5.22215 -5.31395 3.35724 3.77112 +8487 6 54.074 32.5125 15.5854 10.3761 -37.3618 -30.9158 +8488 4 54.8842 32.2065 16.0104 -1.29748 4.29224 -6.87141 +8489 4 53.7047 33.0976 16.2003 -18.9781 34.1452 25.1436 +8490 6 31.1314 3.81684 36.7321 -0.834289 -2.49025 -7.10722 +8491 4 31.1103 4.02948 37.6722 -6.54843 -2.60835 4.18586 +8492 4 30.7135 2.95482 36.5673 3.74099 5.55874 7.56308 +8493 6 11.8386 14.3591 5.9475 31.6488 6.08621 47.6135 +8494 4 11.9235 13.4381 5.72501 -3.84758 -8.60837 -9.73648 +8495 4 12.4264 14.4198 6.78937 -30.0453 0.761866 -39.8937 +8496 6 30.4739 33.6971 6.46755 -23.3776 20.1936 16.0158 +8497 4 30.0841 33.0849 7.09297 -6.22519 -2.1618 10.9649 +8498 4 31.0937 33.1726 6.0102 25.8315 -23.5027 -25.5745 +8499 6 12.7945 0.536645 21.6661 -31.9857 18.4102 -14.2222 +8500 4 12.046 0.975194 21.1709 21.6431 -18.6961 6.09473 +8501 4 12.7507 0.998686 22.5059 13.427 -0.157027 11.5383 +8502 6 52.7685 7.22113 26.1957 6.97037 27.5507 21.845 +8503 4 53.4259 7.92282 26.4698 -21.5773 -21.2317 -16.9414 +8504 4 53.0823 6.78628 25.4103 4.46247 -3.68205 -10.7225 +8505 6 39.7279 40.8849 3.7445 22.9677 17.8938 -40.8272 +8506 4 39.3244 40.0392 3.76563 -12.6427 -25.5287 10.0743 +8507 4 39.6614 41.3038 4.58361 -3.65945 6.85452 27.763 +8508 6 20.1085 31.9188 21.9984 -7.05206 -5.67602 7.13377 +8509 4 19.4287 32.0842 22.6964 14.9272 -8.91322 -13.6161 +8510 4 20.3617 32.7769 21.6609 2.64243 15.0084 0.0829653 +8511 6 12.8674 35.0052 4.44359 43.5281 -46.0898 9.1613 +8512 4 12.2643 35.7062 4.40975 -34.4326 42.8527 -2.74399 +8513 4 13.784 35.3443 4.35073 -14.7319 6.47242 -4.65586 +8514 6 24.0589 33.6612 24.8588 9.55704 11.7193 -6.52578 +8515 4 23.7303 32.9012 24.3903 -5.13736 -12.3884 -10.0474 +8516 4 24.8786 33.8838 24.3903 -2.58553 -1.28908 -1.69824 +8517 6 40.1426 40.9082 22.7393 38.5538 -20.8809 37.5387 +8518 4 39.5402 41.0833 22.0513 -32.6743 7.60774 -19.3027 +8519 4 39.6696 40.5795 23.5226 -1.01773 2.4492 -9.99125 +8520 6 15.5532 2.81426 38.4448 -20.0738 34.0709 23.3703 +8521 4 14.8967 3.48174 38.7749 9.17215 -23.4566 -12.8824 +8522 4 16.1607 3.33672 37.9186 19.8661 -0.634992 -1.43825 +8523 6 41.016 9.18565 16.9561 17.4117 -10.7022 -18.9926 +8524 4 41.8597 8.69641 16.8054 -9.41989 12.8418 6.23764 +8525 4 40.6131 8.73354 17.6887 -9.17188 -2.41438 15.2761 +8526 6 43.1923 41.3931 9.58697 -22.3356 -19.1489 -3.62619 +8527 4 42.3612 40.9845 9.24256 14.3618 0.824315 8.65898 +8528 4 43.3433 0.185675 8.9708 1.58778 19.1204 -6.9238 +8529 6 24.903 37.9158 30.7914 -43.8554 -5.41491 21.3724 +8530 4 23.952 37.804 31.173 48.4757 4.96182 -14.1951 +8531 4 24.7905 38.4252 29.9913 -4.69729 3.46822 -12.8277 +8532 6 2.22055 5.32897 16.4318 -0.704957 11.5959 2.51569 +8533 4 1.8086 4.56809 16.8519 3.25773 -6.94195 4.1641 +8534 4 3.17492 5.17974 16.3235 -2.45649 -10.6256 -1.35481 +8535 6 1.39662 14.9371 19.1386 6.71081 10.2639 18.1623 +8536 4 0.558182 14.6006 18.8448 -10.0768 -10.7254 -15.2923 +8537 4 1.25744 14.8844 20.1022 8.06638 5.64899 -3.4629 +8538 6 34.3184 26.5435 23.7018 12.956 38.2174 -10.8067 +8539 4 33.6096 26.6326 23.0506 -6.28704 -5.42218 7.19498 +8540 4 34.253 25.729 24.1673 -8.0715 -30.4977 4.91012 +8541 6 41.932 21.8144 37.5476 -28.1346 24.458 10.6264 +8542 4 41.9653 21.2973 38.3662 8.82952 -0.726087 -9.88338 +8543 4 41.2985 22.5209 37.8344 14.7394 -10.5077 -10.9774 +8544 6 39.4289 37.6722 12.6363 -7.06663 36.6798 -8.56095 +8545 4 38.7214 38.0767 13.1674 9.12422 -13.2372 3.4836 +8546 4 39.8791 38.4903 12.2996 -0.376717 -30.7746 7.3995 +8547 6 30.2308 35.8744 2.88429 56.3256 -5.17531 19.584 +8548 4 29.7395 35.078 2.8871 -14.5394 -27.2578 -4.40621 +8549 4 29.6846 36.541 2.55195 -33.266 39.3858 -14.7027 +8550 6 50.3691 12.2996 11.0379 -10.7742 -32.245 -38.7061 +8551 4 50.5492 13.1381 11.4098 4.20277 26.7051 25.7379 +8552 4 50.0731 11.6929 11.7162 -2.05651 -3.66514 15.0978 +8553 6 38.4203 1.52686 34.6552 6.3891 -23.1477 32.9209 +8554 4 38.2942 1.9363 33.8354 -7.66336 30.6162 -40.7111 +8555 4 38.1079 0.632206 34.5078 -6.35148 -11.0336 -1.97829 +8556 6 23.4679 32.2557 29.2149 -43.4567 -12.6916 53.2324 +8557 4 24.0296 32.8423 28.7424 12.6247 17.2837 -9.6693 +8558 4 23.1232 32.6929 30.0761 24.9901 -11.6617 -44.232 +8559 6 36.561 38.8488 8.89417 42.7368 2.70764 46.8348 +8560 4 35.962 39.5202 8.64255 -29.9788 24.4889 -23.0747 +8561 4 36.8832 39.1244 9.78764 -11.193 -6.37855 -17.8717 +8562 6 35.882 15.8491 32.4345 4.38917 24.4094 -11.8898 +8563 4 36.1253 15.4284 33.2547 4.1797 -3.844 11.2859 +8564 4 36.4849 16.63 32.3181 -12.6028 -21.8682 2.29862 +8565 6 22.2747 21.8257 41.5848 1.63659 45.0851 -0.0273952 +8566 4 22.1351 22.8132 41.5538 -4.13496 -33.3395 13.1468 +8567 4 23.0832 21.7834 41.079 15.3069 -18.439 -3.51535 +8568 6 24.3693 38.6933 37.0124 5.99709 22.8296 -9.01594 +8569 4 25.2224 39.1901 37.0147 -13.2325 -18.2305 -0.0611307 +8570 4 24.4452 38.0141 37.6805 1.8393 -10.9749 7.25289 +8571 6 45.85 22.0674 16.0435 -6.35855 -11.009 -33.5755 +8572 4 46.1693 22.2375 15.1223 -5.70657 5.73574 25.2515 +8573 4 45.3177 21.2496 15.9445 13.424 8.98362 5.88408 +8574 6 34.0938 26.1451 39.6028 29.3502 -8.72422 32.5359 +8575 4 33.1775 26.2044 39.4639 -36.6108 3.5864 -15.8394 +8576 4 34.1454 26.1252 40.583 9.60862 3.8872 -14.9166 +8577 6 7.22316 36.161 23.2803 -75.9344 2.48999 -44.2827 +8578 4 7.2061 37.0658 22.9632 2.60813 8.07149 -4.69042 +8579 4 7.98979 36.1134 23.7455 79.8131 -8.28428 52.3852 +8580 6 29.1469 40.7664 9.14908 25.9603 -62.9641 -41.536 +8581 4 29.104 40.2522 8.28913 -11.1672 35.4313 19.904 +8582 4 29.7179 40.1086 9.59652 -3.22944 23.7461 21.8778 +8583 6 29.3725 11.2348 1.3024 -38.7794 14.8627 17.4065 +8584 4 28.4703 11.3821 0.891273 31.6728 -0.63192 16.6295 +8585 4 29.2803 11.4968 2.26097 5.36173 -12.1272 -32.3877 +8586 6 30.9813 3.70043 14.0775 0.393287 -12.1193 -7.6118 +8587 4 31.3533 2.81844 14.3971 -7.37725 32.1126 -17.4345 +8588 4 30.796 3.71521 13.098 8.52465 -17.2224 25.8707 +8589 6 29.7018 15.2871 38.2765 -11.7342 18.5436 -44.4423 +8590 4 30.2882 15.1814 38.9925 24.3773 -7.28175 32.8118 +8591 4 30.1059 15.9805 37.6877 -12.7379 -16.9908 17.8861 +8592 6 36.618 0.316233 29.1564 -1.13478 17.6011 -18.8673 +8593 4 37.4497 0.805382 29.2328 -0.537074 -5.31334 10.7084 +8594 4 36.0611 0.935156 28.6408 3.38103 -20.3125 11.7491 +8595 6 47.6566 0.117823 23.249 5.11875 5.73062 -10.5794 +8596 4 46.969 0.414744 23.8324 -12.4062 9.53281 16.9836 +8597 4 47.4018 41.1354 23.0496 0.315762 -17.3342 0.264415 +8598 6 7.91605 37.1729 29.9478 9.96828 38.7234 29.3851 +8599 4 7.8238 37.3188 30.9485 4.22886 -13.4646 -46.5453 +8600 4 8.48708 37.9472 29.6677 -24.8232 -29.7333 9.09982 +8601 6 38.925 24.2263 12.6374 28.6028 -18.1679 -25.4959 +8602 4 37.978 24.1747 12.7226 -16.6271 -1.4443 2.40459 +8603 4 39.1586 23.5255 11.9538 -9.24307 26.9603 22.464 +8604 6 21.3053 26.2545 36.7859 14.9917 45.9325 1.16 +8605 4 20.8074 25.7232 36.1994 -14.2562 -21.9874 -17.8757 +8606 4 21.6248 25.6951 37.4625 3.91421 -21.0802 23.8691 +8607 6 28.2258 23.3284 24.9888 19.6442 1.87868 9.60148 +8608 4 28.2493 24.0261 25.6588 -3.93467 -3.60043 -2.01642 +8609 4 29.1002 22.8932 25.0573 -18.3502 1.43704 -4.70914 +8610 6 38.4116 39.5691 14.5896 29.669 -4.24194 25.1928 +8611 4 38.4978 38.8692 15.3261 -6.52385 31.9806 -37.1925 +8612 4 39.2924 40.0897 14.6163 -46.5668 -30.9815 -6.21074 +8613 6 26.0432 5.99751 38.1148 44.5658 1.98351 30.7371 +8614 4 26.452 6.86444 38.1066 -12.5768 15.2327 -11.4433 +8615 4 26.7959 5.51316 38.5398 -27.2991 -6.53191 -16.0548 +8616 6 52.1237 17.2497 22.5073 -27.4301 16.765 14.7973 +8617 4 52.9399 17.665 22.2571 16.5652 5.20466 -11.3284 +8618 4 52.1578 16.3131 22.3678 7.8945 -19.2066 -9.92552 +8619 6 39.5302 30.1999 31.4498 -15.3908 2.56685 75.4769 +8620 4 40.0207 30.5437 32.2484 0.473519 -4.28305 -35.1019 +8621 4 38.713 29.8928 31.926 18.6512 10.8404 -28.7426 +8622 6 19.6503 6.93083 12.7623 15.8343 -24.4908 21.6207 +8623 4 19.8732 6.46228 13.5959 -20.1786 11.9342 -5.76682 +8624 4 20.303 6.55009 12.1776 -0.0209149 2.55819 -14.5973 +8625 6 32.4196 37.4972 40.0987 12.4446 10.4582 -32.0511 +8626 4 32.8186 36.647 40.0719 9.51079 -23.9505 -16.9607 +8627 4 32.1638 37.519 40.9804 -20.9873 13.1856 56.2462 +8628 6 39.7646 0.344956 6.09395 -0.813604 -13.3118 11.6504 +8629 4 40.0929 1.25666 6.05063 3.72657 -6.06719 5.14874 +8630 4 40.1279 41.7919 6.88268 -2.2039 13.7644 -10.8213 +8631 6 28.7754 10.1494 29.1547 6.27663 8.45441 -17.0952 +8632 4 27.8341 10.1814 28.9557 -5.13507 -0.906004 3.81537 +8633 4 28.9096 9.91312 30.0774 -3.02611 -6.60467 -0.689697 +8634 6 28.3509 21.0738 10.6423 20.1214 -0.517468 -23.7169 +8635 4 28.7452 21.9678 10.604 -10.1652 -7.70852 11.001 +8636 4 28.9796 20.5469 10.1008 -17.263 7.26144 14.8814 +8637 6 27.0689 28.6853 20.8654 35.4789 -5.63144 4.47554 +8638 4 27.7442 29.2307 21.3162 -7.53329 -4.62114 -3.00727 +8639 4 26.2324 28.9644 21.1916 -29.8949 8.87289 15.491 +8640 6 39.6884 13.9755 33.4499 14.6401 2.99861 16.5486 +8641 4 40.0373 13.7827 34.3426 -3.85296 -1.51256 -14.2832 +8642 4 38.7457 13.8219 33.5285 -9.87208 -9.87778 -3.27097 +8643 6 25.4679 11.6581 34.316 -5.2989 -28.5582 40.5924 +8644 4 24.7613 11.1605 34.7897 20.9725 -0.466275 -6.59756 +8645 4 25.003 12.0579 33.6214 -16.717 25.3404 -32.2266 +8646 6 27.5101 37.647 21.4263 -39.7295 -31.2682 -35.969 +8647 4 28.2375 37.1633 21.0518 17.2189 -6.02702 -9.55939 +8648 4 27.8241 38.1534 22.1272 30.3423 24.6719 41.8853 +8649 6 30.5838 20.0489 28.6446 73.221 13.9737 -1.42059 +8650 4 31.1441 19.3945 29.1273 -28.9524 12.9537 -8.0961 +8651 4 29.6632 19.9528 28.6439 -45.0502 -19.2043 6.90743 +8652 6 42.3833 1.8554 14.9243 13.367 3.08275 38.4467 +8653 4 41.8907 2.29225 15.634 5.99337 6.74303 1.17955 +8654 4 41.7769 1.84183 14.2131 -17.6385 -4.20156 -32.9301 +8655 6 12.1633 12.5377 19.5325 -23.0245 -19.867 -11.1113 +8656 4 12.9521 12.0237 19.3369 9.43068 0.576721 5.46819 +8657 4 11.4219 11.8853 19.4518 12.4737 16.4774 1.27947 +8658 6 19.216 1.20416 16.3541 12.5689 2.54581 22.2585 +8659 4 19.6937 0.628292 16.9879 -4.91383 6.35485 -14.1526 +8660 4 19.7889 1.98236 16.2594 -2.22189 -4.72354 -7.2618 +8661 6 9.47695 16.1439 27.6873 23.0793 15.684 -40.8775 +8662 4 9.87411 15.9669 26.7875 -8.00596 11.4199 30.6292 +8663 4 9.27844 15.2819 28.0019 -12.6146 -24.0632 14.4486 +8664 6 40.4558 26.1873 24.7848 -5.87099 -8.07067 -10.9608 +8665 4 40.3772 26.6753 25.6381 -3.45584 0.121614 -18.2296 +8666 4 40.075 26.6842 24.0102 9.21367 0.234889 33.0434 +8667 6 47.6742 17.6493 18.027 -37.0889 26.6143 -3.73366 +8668 4 48.2089 18.0323 18.7522 -4.76487 -3.2939 -8.20899 +8669 4 46.8388 18.2201 17.9217 41.9344 -19.3622 12.4897 +8670 6 36.6073 25.2802 4.19388 18.2149 -9.73143 -24.5863 +8671 4 36.604 25.3887 5.14943 -0.00537736 13.7381 3.83127 +8672 4 37.3627 25.7621 3.76942 -18.9403 0.329358 18.8416 +8673 6 39.5721 35.375 29.6682 7.39129 29.0443 4.37935 +8674 4 38.9992 34.6325 29.7528 -8.39079 -18.7886 -5.10368 +8675 4 39.3389 35.9401 30.4162 6.41301 -4.37294 -4.4287 +8676 6 0.402862 14.6299 13.3406 12.3375 -5.37043 -32.3015 +8677 4 54.737 15.2477 13.6388 -5.18731 7.44473 4.40324 +8678 4 0.540834 14.0191 14.0401 1.19186 -14.994 25.3978 +8679 6 12.2127 27.3484 8.43247 -29.2387 -0.771708 1.75024 +8680 4 12.965 26.7512 8.46983 14.5311 5.0326 6.8656 +8681 4 12.3156 28.1607 8.97491 11.1816 -11.3427 -11.9337 +8682 6 36.8986 14.8167 21.1188 31.0797 27.7575 -31.2238 +8683 4 37.0397 14.394 21.9547 2.6333 -10.7207 26.6181 +8684 4 37.7308 15.3371 20.9125 -24.2604 -24.0664 4.77074 +8685 6 20.8464 4.94114 21.1044 31.4042 5.97012 13.2179 +8686 4 20.3644 5.60924 21.5958 -5.50293 4.43366 -4.7096 +8687 4 21.773 5.03668 21.4416 -23.5272 -13.3128 -11.683 +8688 6 36.7544 1.79945 7.61694 -30.3574 47.6061 45.3867 +8689 4 36.327 2.6686 7.87118 16.8784 -26.1974 -29.8241 +8690 4 36.8428 1.50799 8.53455 15.1793 -22.3797 -11.8231 +8691 6 12.2439 31.5023 37.4569 -32.4985 -2.96535 6.06153 +8692 4 12.7586 31.1596 36.7365 10.4364 1.05198 -9.11954 +8693 4 11.3919 31.0227 37.3953 11.2973 8.58078 9.3944 +8694 6 38.9908 41.586 16.881 -5.73716 8.1645 -10.5856 +8695 4 39.3046 41.7073 15.9766 4.30886 -9.33368 3.06156 +8696 4 39.3667 0.405687 17.3669 3.77504 10.3777 9.96207 +8697 6 31.8904 27.2678 22.2602 -2.97266 4.85738 -46.2508 +8698 4 31.2122 26.6002 22.3915 1.88455 0.488126 10.0993 +8699 4 31.7489 27.4981 21.2895 3.71213 -3.79941 38.8104 +8700 6 42.7405 9.18554 25.589 -22.1194 -12.6454 -9.25487 +8701 4 42.0872 8.82691 24.9599 0.650449 1.17306 7.26361 +8702 4 43.4011 9.54846 25.0154 21.3216 10.0262 -4.62936 +8703 6 50.9383 28.1736 25.3544 -13.6318 0.0171378 28.1732 +8704 4 50.4953 27.5553 24.7803 -5.9639 1.72187 -15.2616 +8705 4 50.5272 27.9992 26.2251 14.2447 5.57945 -12.3971 +8706 6 43.1888 19.6578 30.9105 -66.6531 23.7889 25.5358 +8707 4 44.0873 19.829 30.8982 70.1332 9.75906 -5.84371 +8708 4 42.7965 20.4661 31.3425 9.97757 -17.7871 -10.1322 +8709 6 30.6644 14.0457 40.7997 -18.1309 16.7334 54.243 +8710 4 30.3214 14.3504 41.7092 15.0959 -2.90855 -40.5845 +8711 4 30.1739 13.231 40.7145 -1.19418 -16.8866 -12.4659 +8712 6 20.9131 15.4897 23.0235 5.61878 12.7036 12.8066 +8713 4 20.368 16.1905 23.4302 1.66694 -9.32372 -6.67403 +8714 4 21.8218 15.751 23.2692 -7.37195 -9.57776 -6.18749 +8715 6 34.2171 0.764056 35.8253 8.40959 -35.3498 44.9304 +8716 4 34.6567 1.46863 36.3417 -5.08936 -9.30099 -7.81199 +8717 4 34.1194 41.866 36.4755 2.29033 39.9746 -37.3302 +8718 6 38.9162 36.9098 35.9203 10.0793 6.80115 3.36275 +8719 4 39.7784 37.1612 36.3284 -16.0364 -11.2649 -5.21842 +8720 4 38.6132 36.0588 36.2696 9.66804 2.35098 0.533126 +8721 6 45.1336 25.2146 22.7744 -28.8992 3.863 21.2581 +8722 4 44.1561 25.0943 22.7165 17.1243 8.87651 18.653 +8723 4 45.3983 24.7563 22.0047 17.0602 -12.3694 -29.5411 +8724 6 40.597 0.8134 35.9421 3.227 69.6319 -3.88491 +8725 4 40.5509 41.8059 36.0096 -6.03355 -53.2669 -4.53187 +8726 4 39.9427 1.13471 35.2813 10.0151 -17.6297 16.5691 +8727 6 11.0455 28.3465 35.0235 9.7668 1.71998 -0.601403 +8728 4 10.9819 27.7367 35.7737 -0.960779 4.073 1.47136 +8729 4 10.3922 29.0422 35.1677 -11.8786 -4.48184 3.12795 +8730 6 20.2051 13.5934 35.8566 39.7213 -43.4527 45.4399 +8731 4 19.4813 14.0017 35.4777 -48.9883 30.031 -35.164 +8732 4 20.9868 14.0394 35.5673 14.4182 15.1 -18.5178 +8733 6 39.6245 5.13776 1.76997 -0.951619 9.89005 21.073 +8734 4 38.8252 4.77089 1.41386 -14.9185 -6.12031 -3.7056 +8735 4 40.3018 4.93211 1.13633 15.4903 5.30459 -14.5773 +8736 6 30.2698 30.8736 32.4375 -6.71798 15.6036 14.0469 +8737 4 29.6901 31.1438 33.1751 5.76607 1.99955 -8.25679 +8738 4 29.7896 30.1731 32.0039 1.14172 -17.9152 -6.50707 +8739 6 14.5598 11.0088 22.8703 10.5759 -0.53797 13.7125 +8740 4 15.2344 11.6195 23.3114 -32.0235 -23.0075 -11.5695 +8741 4 13.848 10.7777 23.5118 19.1574 10.2796 -1.34673 +8742 6 20.7379 13.9443 3.00881 5.16887 -45.0314 -26.4616 +8743 4 19.9261 13.6658 2.50706 22.866 18.233 23.793 +8744 4 20.5244 14.6819 3.55007 -16.1173 25.3417 12.2311 +8745 6 41.3029 4.28468 12.6203 -8.04128 10.917 21.7417 +8746 4 40.6152 3.63858 12.7642 -6.82471 -4.23516 2.09603 +8747 4 41.6484 4.11485 11.7651 11.719 -9.67534 -28.974 +8748 6 10.8581 24.7328 21.7161 -39.3585 -15.8792 -33.4515 +8749 4 10.0068 24.8598 21.1989 28.1112 14.2693 20.1969 +8750 4 11.1639 23.9123 21.3137 10.3572 -6.50453 7.69671 +8751 6 53.5762 20.8825 34.3773 -29.6915 -0.0415475 -3.94304 +8752 4 54.5085 20.795 34.3185 33.8519 4.29786 -2.30511 +8753 4 53.2552 20.0612 34.7861 8.83511 12.9473 -9.59804 +8754 6 14.8838 4.84499 30.449 -1.65326 0.839716 -13.8987 +8755 4 14.8578 5.00753 29.4799 -4.93385 -7.75961 17.951 +8756 4 14.5437 3.94124 30.5804 2.28716 7.27432 -2.63088 +8757 6 48.9137 37.1159 13.1232 -44.1315 32.6594 -31.0851 +8758 4 47.9268 37.1149 13.1949 24.5681 4.85746 10.1076 +8759 4 49.2024 36.4546 13.7037 17.9017 -30.2536 24.0784 +8760 6 26.8017 19.3068 7.5379 -15.1037 -1.6612 14.6377 +8761 4 27.3245 18.5243 7.34583 -2.01051 -6.65035 -9.19035 +8762 4 27.3053 20.0577 7.2492 18.4232 10.5976 -10.0514 +8763 6 17.631 11.9383 39.0904 -43.3265 13.8677 10.122 +8764 4 18.4941 11.6307 38.9203 38.4816 -13.6738 2.54756 +8765 4 17.5009 12.0978 40.0481 6.31677 -1.58465 -10.4285 +8766 6 49.9233 14.5931 8.61354 5.83785 -36.2985 -8.08798 +8767 4 49.214 13.9285 8.60404 6.89175 6.08198 5.75816 +8768 4 49.5175 15.3796 8.93642 -5.42274 33.9852 6.11405 +8769 6 32.3642 34.9667 31.5078 2.95354 23.7899 20.5819 +8770 4 32.072 34.4222 30.8036 -4.84614 -18.7532 -16.6478 +8771 4 32.4643 35.8463 31.1217 -0.970967 -0.757054 5.3462 +8772 6 11.8286 22.2266 21.3061 -17.2258 -15.6378 -41.9552 +8773 4 12.2171 21.6669 20.5638 -11.8041 19.7065 26.8676 +8774 4 12.3859 22.1258 22.0497 29.6948 -3.02551 21.8379 +8775 6 33.8509 9.96106 13.6416 -14.3875 -24.3714 -53.1057 +8776 4 33.0123 9.50508 13.4028 8.15621 17.9807 22.2309 +8777 4 34.3201 9.78154 12.7883 7.50726 12.1846 28.7729 +8778 6 25.5192 36.3946 1.51103 -10.4602 3.19395 -11.4439 +8779 4 26.0842 36.7323 0.810141 8.62195 6.50952 5.56913 +8780 4 24.6933 36.9065 1.40961 6.72848 -10.059 1.65156 +8781 6 26.2721 10.5411 9.76409 -19.2005 -4.19702 2.88354 +8782 4 25.6096 11.193 9.42675 5.9346 -6.99241 18.1855 +8783 4 25.839 9.94226 10.4354 7.43867 25.8511 -14.7334 +8784 6 25.016 0.794303 40.8954 13.3669 6.17095 4.00755 +8785 4 25.3682 0.342397 40.1084 -6.19889 9.04785 1.09472 +8786 4 25.4075 1.69244 40.9338 -2.19893 -14.7289 -5.24662 +8787 6 46.2434 3.93626 24.8203 6.94819 -22.6825 -8.03363 +8788 4 46.3834 4.04208 23.8743 3.61713 6.01616 -2.12387 +8789 4 46.2394 2.96647 24.9181 -8.37252 7.22853 3.62774 +8790 6 21.5889 13.6037 29.2057 4.95103 8.76674 17.4208 +8791 4 21.6019 14.3052 29.8879 -2.51331 -9.966 -5.68557 +8792 4 21.3126 14.082 28.4253 -2.16645 0.501775 -6.52993 +8793 6 36.7737 38.3803 0.360926 -13.0762 -25.442 -6.6792 +8794 4 36.4499 39.0355 0.978203 -4.80976 12.188 0.88021 +8795 4 36.0266 37.7487 0.22189 15.835 12.8395 4.19355 +8796 6 19.3086 17.6338 24.0617 47.0109 35.6134 -17.5995 +8797 4 18.4263 17.3722 24.1632 -50.3154 -15.1751 2.93786 +8798 4 19.3137 18.3511 23.365 -2.62926 -22.9616 14.087 +8799 6 23.1803 12.6945 3.50697 -12.4047 4.12184 -0.296296 +8800 4 22.2521 12.9621 3.30307 10.5621 -3.58256 -0.535563 +8801 4 23.3663 11.8631 3.0578 -9.23841 -1.30096 -1.53094 +8802 6 37.8891 8.88353 35.4651 -18.9945 -25.3999 -47.3866 +8803 4 38.8166 8.83127 35.1934 2.77199 2.98421 7.2207 +8804 4 37.4068 8.32521 34.752 23.9265 29.6152 37.0755 +8805 6 14.3237 15.1253 36.1844 10.7536 -1.62675 -12.1114 +8806 4 15.0418 15.7291 36.3902 7.37284 -3.65767 0.0646607 +8807 4 13.765 15.154 36.9379 -17.7819 2.51157 18.8211 +8808 6 35.0801 0.941274 33.018 -10.8249 30.7834 33.3167 +8809 4 34.9269 1.883 33.2395 6.71896 -7.58638 -28.1375 +8810 4 34.9733 0.615676 33.9226 0.339269 -19.4543 -11.259 +8811 6 50.9271 0.518298 17.9933 -4.01299 -8.33658 -1.61011 +8812 4 50.7551 1.39133 17.5891 -0.713529 -12.5397 8.99793 +8813 4 50.17 41.8323 17.8017 14.8721 13.6567 -6.57092 +8814 6 26.2328 30.5636 0.934374 -8.95911 39.2037 50.9017 +8815 4 26.9657 31.1139 1.27364 -12.5333 -13.1029 -5.86431 +8816 4 26.5352 30.0815 0.207089 19.4446 -20.9762 -37.1203 +8817 6 18.5681 38.3031 4.5613 16.0408 -0.4472 -12.493 +8818 4 17.6336 38.3732 4.40187 -16.7548 5.85511 1.82222 +8819 4 18.9561 38.7121 3.75593 -0.616515 -6.35836 15.3023 +8820 6 31.1349 5.07457 4.1166 35.5071 -12.4218 -11.0008 +8821 4 31.9258 4.61163 4.53765 -37.2933 13.7034 -13.5003 +8822 4 31.2792 5.02565 3.1391 -9.10044 -1.2591 17.9933 +8823 6 26.4378 21.892 1.49191 0.117022 -23.7737 9.75083 +8824 4 26.3504 22.7277 1.07049 4.38069 30.3527 -12.7348 +8825 4 27.3618 21.6023 1.50897 -0.762137 4.81239 -9.09803 +8826 6 39.2154 11.7026 22.7855 15.1366 1.14561 24.1899 +8827 4 39.8619 11.6546 23.5153 -3.42244 7.72178 -8.31759 +8828 4 38.7922 10.855 22.8508 -11.0077 -10.6036 -7.38167 +8829 6 13.6049 36.3215 30.6697 16.8779 70.0034 -37.8159 +8830 4 13.9417 37.1302 31.1268 -10.116 -30.1168 -5.71441 +8831 4 13.4922 35.6039 31.2515 -3.36872 -19.2676 30.0327 +8832 6 50.5831 9.86782 9.34675 -39.9446 -18.2052 0.719337 +8833 4 49.679 9.5553 9.65542 27.7691 6.62521 -8.8993 +8834 4 50.7343 10.6656 9.84378 7.47556 12.1458 9.31829 +8835 6 49.6659 40.3022 22.5839 -5.95569 -23.2057 2.00246 +8836 4 49.9088 39.3695 22.3976 1.04597 17.1639 -6.42107 +8837 4 49.3089 40.2511 23.4853 9.00681 3.37443 -0.55643 +8838 6 7.21026 41.318 28.8937 -13.882 28.5523 32.2899 +8839 4 7.13277 41.6426 29.851 5.74914 -19.7174 -37.6289 +8840 4 7.14599 0.215754 28.3517 11.7183 -8.26627 3.5395 +8841 6 13.0317 18.008 25.3351 57.1177 45.3919 41.6622 +8842 4 13.702 18.0765 24.6297 -18.9881 -2.87884 -2.05071 +8843 4 13.5608 18.5052 26.1022 -41.5403 -41.2906 -37.5185 +8844 6 50.0508 19.5822 2.43378 8.05757 -12.3534 -25.4868 +8845 4 50.6415 19.2321 1.70522 -9.91294 15.3245 28.3035 +8846 4 50.4964 20.3068 2.88656 9.48594 2.0046 -2.18375 +8847 6 28.3417 40.9623 24.5247 28.1527 -9.28969 -2.11238 +8848 4 28.8808 40.6229 23.7869 -8.53201 1.00989 5.926 +8849 4 27.851 41.6822 24.1702 -24.0642 17.3603 -12.6153 +8850 6 19.4173 5.36544 29.5282 -16.7292 -1.42659 17.4998 +8851 4 20.0576 6.03033 29.2802 12.6037 1.87093 -5.71578 +8852 4 18.8017 5.84191 30.1159 0.735032 -8.12986 -7.95209 +8853 6 35.3107 40.1454 22.2712 -2.40765 19.7984 -7.699 +8854 4 35.7006 39.9699 23.1142 6.54418 -16.9762 14.0951 +8855 4 35.2702 41.1078 22.294 -0.592679 0.794763 -5.20647 +8856 6 16.1889 33.7724 9.7458 10.3229 10.2088 29.582 +8857 4 15.8959 33.2543 9.01299 -6.07516 -13.8809 -16.7379 +8858 4 15.6715 34.5759 9.82028 -7.73583 2.776 -7.11592 +8859 6 17.3675 40.6445 20.2267 0.0256395 24.2963 -9.09373 +8860 4 17.2094 39.7816 20.6122 1.5629 -5.58702 6.23448 +8861 4 17.4758 41.3298 20.9152 1.51783 -13.2527 0.49298 +8862 6 20.5171 9.72867 9.58726 35.059 7.05341 -25.1666 +8863 4 21.2226 9.96362 10.213 -13.2653 -0.810893 -5.91795 +8864 4 19.8248 9.38464 10.113 -26.7953 -13.816 19.6743 +8865 6 47.4426 20.1922 21.3765 55.2231 -18.8128 34.629 +8866 4 48.295 19.6294 21.3384 -41.3243 22.9169 -3.74061 +8867 4 46.9816 20.0754 20.5659 -14.9725 -5.50706 -31.0177 +8868 6 38.4071 40.79 37.8146 12.3234 -22.6201 -9.80787 +8869 4 38.1404 41.7017 37.8605 -3.64711 23.1989 -4.06141 +8870 4 38.2696 40.4362 38.6954 -10.1247 -0.131598 9.15413 +8871 6 4.78578 1.94641 13.1038 0.280311 5.55092 -8.42179 +8872 4 4.79931 1.2475 12.4246 2.88607 5.75183 11.0778 +8873 4 4.58324 1.57529 13.9639 -2.31824 -10.9024 4.61034 +8874 6 46.8249 29.0091 2.16845 3.76482 2.94797 40.2579 +8875 4 46.7332 29.1215 3.14399 -15.0191 0.321828 -28.5005 +8876 4 47.6691 28.5689 2.15078 10.7116 -9.65214 -17.1948 +8877 6 37.4359 26.1653 25.6478 9.30824 1.4869 -5.75173 +8878 4 37.1837 25.5346 26.3178 -5.80587 -7.25577 3.90549 +8879 4 36.6384 26.5534 25.3025 -7.59782 4.42715 -0.0787482 +8880 6 27.3269 4.19583 19.442 5.96538 17.8772 -24.7701 +8881 4 28.0114 4.58146 18.8428 -3.77368 -14.8915 15.8068 +8882 4 26.5277 4.61529 19.0816 -6.14884 -6.84507 9.70558 +8883 6 29.57 35.1706 32.6629 9.65469 -19.4491 -13.9626 +8884 4 29.5306 34.4116 32.0191 -0.1659 24.8691 21.1709 +8885 4 30.4743 35.5004 32.5856 -0.51053 -0.290213 -2.43375 +8886 6 51.6097 27.3863 34.6091 -31.2455 30.913 9.06642 +8887 4 51.929 26.6019 35 16.42 -40.5282 7.55135 +8888 4 52.0725 27.582 33.8009 7.9649 -1.59603 -13.3915 +8889 6 26.2078 15.7281 22.6941 16.538 -21.7488 31.7554 +8890 4 25.9667 16.5615 22.3191 -8.70869 23.0893 -12.8942 +8891 4 26.0629 14.9994 22.0993 -9.54979 -3.97748 -17.7982 +8892 6 36.1239 41.1986 15.4707 -7.45359 -19.8962 -4.3143 +8893 4 35.6999 40.3419 15.2987 -9.47391 11.3121 -0.409552 +8894 4 37.0386 40.9374 15.4513 15.7433 3.85103 -0.545832 +8895 6 18.465 8.81345 11.2165 5.38391 10.0618 1.17025 +8896 4 18.7987 8.15135 11.8182 8.53154 -1.35082 11.1952 +8897 4 17.7161 8.38168 10.8393 -16.7411 -2.38381 -11.2186 +8898 6 30.2088 21.3096 23.2049 -11.6688 7.62645 -9.73036 +8899 4 29.9671 22.1993 22.9248 4.97058 -0.914249 3.78278 +8900 4 29.5299 20.7541 22.7893 7.94877 -1.13118 2.47612 +8901 6 22.73 2.20521 34.8374 1.74432 -25.8699 49.3747 +8902 4 22.3572 1.29354 34.8889 6.16039 22.5731 -10.8251 +8903 4 22.7018 2.4887 33.9486 -6.75325 10.5307 -40.1895 +8904 6 12.6909 2.75059 12.3422 -14.3125 16.3183 -13.6311 +8905 4 12.533 3.61796 11.8786 11.7453 -23.2619 14.9881 +8906 4 13.1336 2.19907 11.6816 1.83842 1.45343 3.2847 +8907 6 24.107 30.0639 14.5719 -73.5796 11.8292 4.65098 +8908 4 23.699 30.7611 15.1345 32.1371 -0.343623 -0.31889 +8909 4 23.2337 29.7156 14.2286 43.085 -3.68866 -7.89372 +8910 6 0.015177 27.9048 22.8533 -2.756 -4.53229 -2.63487 +8911 4 54.6492 28.3778 23.623 -8.36257 -3.01834 -6.1652 +8912 4 54.216 27.6514 22.3224 8.23112 8.70814 10.2495 +8913 6 12.3617 4.4844 25.9108 40.9735 -25.7794 -17.3291 +8914 4 12.201 5.40791 25.8162 -22.6464 21.2272 1.21762 +8915 4 11.6198 4.00067 26.267 -15.5784 4.93476 10.9426 +8916 6 50.6578 14.4652 5.91353 -13.9437 -6.30553 43.3918 +8917 4 51.4397 15.014 5.76935 2.55266 2.90763 -3.8133 +8918 4 50.4787 14.4827 6.92851 9.15248 3.54798 -49.9389 +8919 6 52.5668 22.873 20.1428 -12.6564 -29.9263 -28.8801 +8920 4 52.956 23.3393 20.8718 4.45243 13.9606 14.107 +8921 4 52.7899 23.3428 19.3246 -0.129831 10.341 11.583 +8922 6 43.5892 16.524 12.8775 29.595 -3.78245 -19.1347 +8923 4 44.3058 16.0087 12.3806 -28.6005 27.9094 23.6723 +8924 4 42.7982 16.4888 12.3437 -11.2315 -8.54457 -10.2035 +8925 6 15.9661 16.7487 40.5866 1.44034 32.7745 -1.20572 +8926 4 16.4126 17.3388 39.9207 -12.1014 -18.8104 17.452 +8927 4 15.5985 17.3766 41.2587 12.5036 -14.614 -16.5617 +8928 6 23.4158 18.8712 23.8473 -16.0774 -11.4939 3.2157 +8929 4 23.4518 19.2692 24.728 -0.157295 3.62127 -3.85719 +8930 4 22.4941 18.9757 23.5436 12.0607 -0.266031 2.57498 +8931 6 46.4178 3.27548 31.8952 19.5415 -1.29071 -17.2416 +8932 4 45.5866 3.26999 31.4067 -8.61336 -0.166695 4.01481 +8933 4 46.2657 3.3297 32.8359 -5.35267 1.32166 2.09612 +8934 6 43.4045 41.0584 12.2875 -8.04746 -23.5947 4.76735 +8935 4 43.6693 41.8276 12.7696 6.05224 12.9314 10.8988 +8936 4 43.5172 41.2728 11.3626 0.904796 3.93503 -13.2342 +8937 6 7.4976 32.4756 29.5884 -13.7893 55.6862 -12.0377 +8938 4 8.07142 31.7837 29.8334 27.4303 -26.9633 6.13269 +8939 4 8.04212 33.3166 29.512 -13.0153 -27.2422 -1.65156 +8940 6 4.77821 31.644 22.4997 2.28771 28.4048 16.4959 +8941 4 5.27411 32.2412 23.0928 2.56389 -13.4484 -8.63656 +8942 4 4.12057 32.2584 22.1518 -1.39427 -10.0394 -7.16978 +8943 6 48.879 26.8662 2.67919 -5.86075 -60.7959 24.9619 +8944 4 49.7001 26.7095 3.23946 -26.2991 7.4186 -32.0291 +8945 4 48.3448 25.9902 2.75892 28.4546 51.6452 -6.88552 +8946 6 35.3626 23.261 21.6242 -2.7789 -2.57103 6.54281 +8947 4 36.2261 22.8974 21.81 4.94258 -15.6751 6.88864 +8948 4 35.5426 23.9136 20.9639 -1.02428 17.548 -23.8062 +8949 6 9.79934 37.7758 27.3048 16.52 16.637 17.9603 +8950 4 9.72643 38.6113 27.803 -16.1555 -8.36248 -12.7831 +8951 4 10.5885 37.4189 27.7206 -2.15823 -16.4776 -5.60851 +8952 6 6.95685 10.9812 25.9821 -25.178 -21.2877 -4.97438 +8953 4 6.33357 10.2528 25.7268 23.179 21.9129 0.503821 +8954 4 7.29095 10.6974 26.8328 9.60603 -1.481 14.6966 +8955 6 15.9965 34.4888 38.9273 -2.91878 -3.91161 19.3063 +8956 4 16.0374 33.5463 38.7461 4.95306 -0.665665 -16.4822 +8957 4 15.9715 34.4958 39.9054 -7.59103 5.72172 -22.2107 +8958 6 24.1167 17.3197 36.1615 15.3363 -47.5124 0.380375 +8959 4 24.7173 17.5753 36.8648 1.58194 5.49031 12.5141 +8960 4 24.1546 16.3101 36.2205 -9.7187 30.8811 -7.11116 +8961 6 29.9757 19.0472 5.63639 12.788 -31.6225 11.2379 +8962 4 30.1584 18.5328 6.46799 -12.7316 12.501 -21.5451 +8963 4 29.4206 19.7916 5.84051 -11.4929 16.6696 15.0892 +8964 6 41.2293 14.2018 25.873 -1.75888 28.9255 -23.3251 +8965 4 41.1078 15.0995 25.4693 3.83492 -22.0907 13.098 +8966 4 41.2654 14.3268 26.8215 3.7207 5.50516 9.94654 +8967 6 30.6006 17.7874 37.3562 -24.7598 46.8721 10.074 +8968 4 30.0173 18.4181 36.8416 23.2796 -25.9316 -1.25214 +8969 4 30.633 18.2764 38.2118 8.15578 -14.795 -8.30511 +8970 6 36.2662 35.7599 28.8527 -12.8707 -30.9202 21.2821 +8971 4 36.6718 34.9534 29.2396 -10.1595 12.442 -4.1956 +8972 4 37.0218 36.2801 28.6478 17.3511 22.2532 -11.5483 +8973 6 0.195836 37.8645 20.3851 -23.6217 6.21569 -13.9532 +8974 4 0.549498 37.2778 21.0637 4.94615 -2.95215 -2.70832 +8975 4 54.3862 37.4234 20.0075 16.4722 8.11718 6.90773 +8976 6 49.5165 39.5896 25.2714 -0.622408 -34.3922 32.9891 +8977 4 49.1772 39.7667 26.1925 10.9208 -1.11318 -32.3029 +8978 4 49.8261 38.6352 25.2806 -10.9036 35.658 1.81375 +8979 6 21.6574 10.1952 29.3538 -5.06277 -0.743802 10.2318 +8980 4 21.4664 11.1105 29.223 -3.01111 19.5458 -20.3057 +8981 4 21.662 10.2064 30.3052 9.73006 -17.7161 13.8831 +8982 6 36.4636 30.0567 0.119709 9.37859 61.6807 38.5429 +8983 4 36.3123 29.4684 41.3206 -1.21017 -23.1836 -37.505 +8984 4 36.9143 30.908 41.7057 -13.4567 -39.5067 4.20368 +8985 6 35.2344 23.3726 39.1433 31.8417 -88.9919 -51.9106 +8986 4 35.0278 23.5012 38.2069 -5.96056 -5.38998 8.96032 +8987 4 34.9909 24.127 39.538 -31.8308 96.9265 45.0865 +8988 6 25.4761 17.6258 38.7257 1.29934 8.28965 -16.1346 +8989 4 26.2031 17.0769 39.0234 13.7946 -6.33455 1.86524 +8990 4 25.7107 18.4933 39.0598 1.3782 7.33891 4.86011 +8991 6 32.6846 1.71002 15.3734 -11.6254 -20.3205 21.5399 +8992 4 32.9453 1.93093 16.3086 -8.96834 -8.53877 -20.2534 +8993 4 32.154 0.853232 15.3925 19.204 32.1949 4.36426 +8994 6 2.7574 26.2382 40.1716 -4.40087 -21.6692 -50.7652 +8995 4 2.38718 26.7949 40.8139 -8.13358 26.7101 38.7547 +8996 4 3.41358 25.6429 40.5298 13.0891 -5.49009 7.80053 +8997 6 25.4307 39.5752 6.64887 -26.4755 -1.32722 14.1102 +8998 4 25.8932 39.0809 7.30961 27.038 -6.17916 -3.25304 +8999 4 24.5458 39.4465 7.03066 -2.44587 12.932 -21.9634 +9000 6 3.88975 2.45855 21.1879 28.3389 -91.355 -25.6726 +9001 4 3.44478 1.54109 20.9736 25.4092 48.4753 9.01111 +9002 4 3.19228 2.99847 21.4284 -47.2055 43.8768 12.3888 +9003 6 19.4353 35.9908 6.17834 -1.98144 -11.1023 18.0698 +9004 4 18.7425 35.7628 6.83514 2.39623 12.5316 -16.1317 +9005 4 19.0828 36.5127 5.45195 -11.0597 11.4176 1.1294 +9006 6 53.664 10.8386 34.7899 -0.427116 -3.27611 41.7292 +9007 4 53.6105 10.6836 35.7561 -1.66612 -17.5448 -26.7849 +9008 4 53.9652 11.7272 34.8329 4.68725 29.9217 -18.2793 +9009 6 51.2799 14.0867 34.6651 -29.2798 -10.9719 -23.3019 +9010 4 50.6522 13.5411 34.1107 26.8684 18.9114 5.01949 +9011 4 50.9895 13.8814 35.5479 1.81167 -5.08277 17.6681 +9012 6 14.4338 40.0198 28.0288 -0.147098 23.5255 27.6002 +9013 4 13.7688 39.3521 27.8218 1.28331 -8.25373 7.75106 +9014 4 14.1948 40.5222 28.8704 -0.878391 -19.6822 -29.209 +9015 6 36.0552 40.8569 1.29319 48.4065 13.1893 15.2608 +9016 4 35.4421 41.0883 1.96787 -21.4185 -0.412662 13.5205 +9017 4 36.896 41.2683 1.66088 -27.5471 -12.7345 -18.5843 +9018 6 32.5846 21.8706 9.62772 14.4951 6.80277 0.680584 +9019 4 32.1936 21.3098 8.97285 -7.2875 -23.9506 -7.81502 +9020 4 32.858 22.6104 9.08324 0.955029 10.0343 1.40437 +9021 6 53.7602 11.4574 10.0748 -7.70253 -4.89045 -17.0247 +9022 4 54.6558 11.7035 10.3272 3.70339 -10.2166 -5.16833 +9023 4 53.8328 10.8374 9.31644 -2.27357 5.83713 13.9933 +9024 6 25.443 2.0669 35.0212 -16.7533 17.7231 -21.4763 +9025 4 25.6415 2.91576 34.5502 -7.64634 -16.7974 11.4347 +9026 4 24.4652 2.09352 35.1703 17.3945 -2.11295 -4.26167 +9027 6 38.4088 16.3775 27.0777 23.4896 -26.556 7.92078 +9028 4 38.4029 15.905 27.9411 -0.72651 18.7119 -5.4255 +9029 4 38.1233 17.2789 27.1678 -4.67214 15.3602 11.0072 +9030 6 11.9834 11.8283 38.0863 1.50515 -20.9897 -19.5245 +9031 4 12.337 12.445 38.7318 -5.05033 4.06408 7.46746 +9032 4 11.0493 11.6049 38.244 7.06215 11.5652 6.68382 +9033 6 21.1646 40.7247 25.8949 30.8575 -6.32012 -20.5276 +9034 4 20.7152 41.4784 25.5554 -14.4662 20.9939 -18.0031 +9035 4 20.8194 40.6451 26.758 -13.9443 -15.9826 36.5019 +9036 6 5.45737 31.2526 28.1092 12.1805 15.5126 -2.48606 +9037 4 4.77986 31.7446 27.6301 0.776808 -0.764161 -8.53258 +9038 4 6.21204 31.8695 28.2031 -7.61365 -6.18966 7.74582 +9039 6 38.5666 10.4345 26.6322 12.4833 -8.23035 1.5222 +9040 4 39.2815 10.9281 26.2104 -2.91177 1.8082 -0.00903947 +9041 4 39.0293 9.89744 27.2937 -7.88948 5.75886 -1.98766 +9042 6 34.5704 22.2441 5.77364 -5.35359 -6.12765 6.5276 +9043 4 33.6261 22.329 6.01336 10.9983 8.59631 1.2651 +9044 4 35.1361 22.6291 6.46875 -10.1328 -5.43064 -4.61746 +9045 6 19.508 23.4157 8.91293 -5.78488 4.73981 5.04963 +9046 4 19.7274 23.1974 9.83518 1.16663 -6.94775 -9.92836 +9047 4 19.9131 22.8043 8.29809 9.12387 -6.1547 2.91491 +9048 6 19.7424 39.1606 18.9462 6.36032 12.2479 8.14591 +9049 4 20.3561 39.0422 19.6872 -3.85164 -4.35394 -5.20149 +9050 4 19.0738 39.7495 19.3414 -1.06489 -8.07777 -11.9442 +9051 6 19.0057 16.6591 37.8853 37.3334 -16.7993 4.17439 +9052 4 18.1861 16.4809 37.4823 -32.8062 -2.38488 -19.1553 +9053 4 18.8146 17.2984 38.5514 -2.10283 15.4454 14.1988 +9054 6 46.1541 18.3125 34.4675 -16.9871 7.29415 15.254 +9055 4 46.1595 17.7325 33.7168 0.615393 -10.1859 -17.2384 +9056 4 45.2376 18.6499 34.5058 9.28079 -5.03019 -2.85447 +9057 6 37.6537 4.93165 10.635 20.1552 -8.04423 -16.7256 +9058 4 38.5399 5.21744 10.272 -26.6503 -7.30776 7.98139 +9059 4 37.1074 4.55852 9.88971 22.9932 21.6332 27.1334 +9060 6 51.9792 36.004 6.8478 30.791 3.18545 -0.726681 +9061 4 52.2413 36.7963 6.35992 -14.9215 -4.55469 -2.53046 +9062 4 52.8266 35.8818 7.33626 -22.3254 6.63746 5.40006 +9063 6 26.6741 12.3268 1.0034 -10.7024 -25.4666 -34.2692 +9064 4 26.4988 12.3574 1.94138 -4.81655 1.43394 14.8604 +9065 4 26.0954 11.585 0.663483 16.9242 17.5219 15.4646 +9066 6 51.3423 35.7724 13.5298 -0.266216 29.5034 10.6004 +9067 4 51.4043 36.4131 12.804 2.34884 -4.4098 -1.45811 +9068 4 51.4073 34.9167 13.1542 5.41074 -27.2154 -15.541 +9069 6 1.98873 3.64285 24.5869 25.9971 69.8048 -55.2188 +9070 4 1.65752 3.03018 25.1632 -30.3002 -46.9535 54.3289 +9071 4 1.71436 4.54846 24.8879 2.6309 -26.2008 -0.982747 +9072 6 33.5221 15.2795 16.4506 0.0536135 -15.838 -38.1617 +9073 4 33.6476 15.3964 15.4593 -8.63578 3.82522 35.1416 +9074 4 33.7341 16.1085 16.8736 8.85342 14.4801 4.37501 +9075 6 10.7227 26.5775 37.3442 -67.903 54.2831 -20.645 +9076 4 10.2191 27.0779 38.0369 14.5194 -13.2702 -3.80745 +9077 4 11.4784 26.2608 37.7268 68.0232 -30.094 41.6962 +9078 6 39.6271 8.38119 31.999 1.44949 -5.13238 35.1009 +9079 4 39.1996 8.85287 32.7464 5.61163 -5.5592 -21.3265 +9080 4 39.0885 8.45634 31.2221 -15.3514 9.3045 -12.0182 +9081 6 48.873 24.2439 11.5987 1.10357 -37.2725 -9.21005 +9082 4 49.1825 23.3167 11.4023 -5.65288 27.9965 8.32055 +9083 4 49.5986 24.6511 12.0826 3.19491 3.15896 -2.50749 +9084 6 15.8098 8.51994 22.5326 -12.5814 0.672941 2.19285 +9085 4 15.7588 8.52265 21.5683 10.3815 2.49136 4.36748 +9086 4 15.4206 9.36801 22.7863 6.5895 4.65597 -0.371293 +9087 6 16.9392 23.5364 7.95083 25.1749 21.5498 -34.0775 +9088 4 17.2079 23.9031 7.093 -25.8979 -5.01679 3.50755 +9089 4 17.8126 23.4623 8.29573 16.7216 -7.09478 32.6865 +9090 6 42.4825 26.8555 6.33102 0.60087 7.54144 -12.7632 +9091 4 41.764 27.4892 6.46083 9.75026 1.01062 3.5184 +9092 4 43.14 27.3488 5.78659 -9.42643 -3.33158 7.6404 +9093 6 36.8078 4.79995 30.0438 -4.74249 18.2042 -3.85385 +9094 4 36.952 4.89746 30.9922 3.10706 -1.8894 0.559973 +9095 4 36.294 4.02131 29.8808 -10.4691 -15.4659 3.71438 +9096 6 45.6128 11.6142 3.31163 15.5246 21.1623 13.6733 +9097 4 45.8972 10.701 3.31117 0.727629 -14.3179 7.30305 +9098 4 46.2501 12.0834 3.90994 -13.3278 -10.7206 -15.6492 +9099 6 24.8943 36.3842 21.2731 0.145584 -0.0155718 21.9832 +9100 4 24.5073 36.3627 22.1568 -5.92138 3.86098 -2.91089 +9101 4 25.79 36.6624 21.4916 7.30899 1.2523 -13.3669 +9102 6 31.8172 24.7218 2.44079 24.9542 32.077 -0.738567 +9103 4 31.5948 23.8911 2.82575 -7.26237 -24.1795 3.52598 +9104 4 32.7966 24.7848 2.51706 -20.2581 -1.29655 -5.98664 +9105 6 24.135 21.9795 37.225 -18.6422 57.7065 19.5247 +9106 4 24.1223 22.9841 37.1061 1.06209 -41.2434 9.50937 +9107 4 24.7129 21.6948 36.5371 13.1815 -12.7877 -24.1492 +9108 6 37.1979 11.5342 15.06 20.8972 -17.7328 -40.5152 +9109 4 38.0246 11.7972 15.4709 -1.33045 5.21986 19.7962 +9110 4 36.429 11.9138 15.4438 -18.178 22.6449 25.793 +9111 6 36.4751 20.3399 41.7845 -26.5497 -48.0551 41.2862 +9112 4 36.3228 19.4621 41.3748 1.60744 11.8178 -3.29004 +9113 4 36.9246 20.873 41.191 27.5593 28.4699 -43.2619 +9114 6 32.0497 37.9214 32.6612 -32.2386 -8.50634 -18.7459 +9115 4 32.4337 38.7163 32.9803 20.8647 20.5609 12.2985 +9116 4 31.3654 38.2694 32.0613 5.31663 -14.2519 5.69849 +9117 6 12.0395 39.928 22.5123 -26.9832 36.7812 23.3187 +9118 4 12.2839 40.8414 22.1926 -3.01474 -29.6796 4.86816 +9119 4 11.2932 40.0883 23.1662 29.524 -10.585 -25.0576 +9120 6 26.3406 1.33526 19.2893 15.6729 -20.8034 13.8388 +9121 4 26.8411 0.655996 19.8199 -14.5491 24.9752 -14.9066 +9122 4 26.8003 2.1813 19.3861 0.112049 0.00336314 -1.02908 +9123 6 5.91669 14.3164 5.69097 2.29729 -16.5161 -30.3395 +9124 4 6.30102 14.1024 4.7902 -6.32478 5.25084 23.5077 +9125 4 5.06552 13.8494 5.70115 7.33482 -6.30923 1.55114 +9126 6 13.3703 23.089 19.1627 -28.3895 15.3871 14.4757 +9127 4 14.1086 22.8122 18.6632 27.2898 -8.01563 -16.6587 +9128 4 13.6991 23.742 19.8005 3.67942 -13.964 0.879599 +9129 6 23.4058 15.0688 9.73621 -4.11719 1.06855 12.2005 +9130 4 22.5732 14.661 10.02 0.657405 4.9462 -7.25364 +9131 4 23.2196 15.7347 9.05868 -5.70535 0.38861 -5.0655 +9132 6 49.5812 13.8288 18.4474 0.101153 1.0527 41.008 +9133 4 48.8214 13.4814 17.9923 -8.96247 -7.71084 -15.1851 +9134 4 50.2052 14.1722 17.8367 10.7879 13.5653 -33.2962 +9135 6 41.7444 5.67096 41.8915 25.5819 0.859229 17.1787 +9136 4 42.5704 5.9364 0.475256 -21.6624 -6.74737 -14.5764 +9137 4 42.0361 4.9893 41.2645 -5.04703 6.59959 -2.77397 +9138 6 17.2492 35.5437 2.55512 -4.98919 17.2489 6.23124 +9139 4 18.1963 35.629 2.41282 7.59523 -3.20753 1.41995 +9140 4 16.9663 34.6563 2.38439 4.57262 -16.6324 -5.73806 +9141 6 49.6936 19.8647 40.242 36.1149 -8.05295 1.41344 +9142 4 49.24 19.0314 40.466 10.1916 2.45634 3.62304 +9143 4 50.6901 19.7225 40.3055 -34.6505 -2.12616 -4.55887 +9144 6 38.3055 5.83107 32.0437 -25.1209 3.13983 17.5072 +9145 4 37.8566 6.51058 32.5952 5.57321 -12.5864 -8.78808 +9146 4 39.2068 6.11217 32.0045 20.6085 6.27671 -1.8315 +9147 6 16.2656 6.85278 34.0134 13.6308 -7.44031 -0.955967 +9148 4 16.5278 6.7006 33.1016 -0.686465 1.61317 -6.98637 +9149 4 17.0706 6.57794 34.496 -11.7464 5.49098 9.02554 +9150 6 33.6779 18.1919 10.4599 39.833 -25.9405 -6.08719 +9151 4 34.2274 18.843 9.984 -7.48822 -11.4027 6.26591 +9152 4 34.2403 17.3374 10.5556 -30.6671 44.9369 -7.76686 +9153 6 38.8896 33.7563 36.7672 22.7659 10.9801 -36.8997 +9154 4 38.4264 33.5452 35.9055 8.66825 7.19978 21.2858 +9155 4 39.8358 34.0039 36.5278 -27.7603 -15.0244 3.77145 +9156 6 45.3747 13.0912 20.2115 -8.54575 18.1695 38.2532 +9157 4 45.1986 12.6554 19.3957 -4.2418 -14.8759 -23.2281 +9158 4 44.5273 13.1029 20.6991 7.89471 -4.73094 -13.0554 +9159 6 36.3919 32.2126 8.83938 1.15121 -2.28434 -1.4136 +9160 4 36.3207 31.3933 9.34391 1.93757 3.36082 7.91897 +9161 4 36.0586 32.9456 9.38554 -3.10773 -8.06217 -4.51958 +9162 6 7.93399 27.8164 6.18652 -8.84441 8.26416 -30.5327 +9163 4 8.20753 27.2416 6.88401 9.15323 -7.03573 14.7081 +9164 4 8.30192 28.6748 6.41842 -5.04409 0.971707 0.751098 +9165 6 14.2889 4.87494 33.6812 -48.074 -5.72289 -27.637 +9166 4 13.5426 5.15568 33.0467 38.2298 -5.02982 23.8683 +9167 4 14.8103 5.65434 33.8518 10.0815 16.0504 2.39638 +9168 6 12.247 8.64363 9.86387 9.5307 8.47707 -42.9656 +9169 4 12.7265 8.83196 10.6522 4.83417 -1.95201 32.3898 +9170 4 11.3733 8.28369 10.003 -7.27928 -7.56138 14.4849 +9171 6 29.7193 31.982 8.5339 -11.3757 5.45371 -22.6092 +9172 4 30.2272 31.7973 9.28681 18.5431 -1.21859 37.4341 +9173 4 29.7513 31.1489 8.05875 -9.95983 -0.182644 -6.87416 +9174 6 22.3912 10.8818 21.4749 22.6973 -30.3469 0.856054 +9175 4 21.7953 11.1177 20.7819 -19.5872 13.8984 -18.5017 +9176 4 22.3568 11.5583 22.1363 -13.7305 16.7548 8.89642 +9177 6 54.1825 27.5382 12.9949 16.0749 -34.873 29.2784 +9178 4 0.169556 27.5337 13.075 -9.84187 5.32432 -2.29215 +9179 4 53.8855 28.25 12.4714 -3.97587 36.1158 -26.3516 +9180 6 7.7322 13.8127 20.037 -51.4252 10.19 -38.2554 +9181 4 8.32211 14.101 20.6974 26.6579 16.8549 28.1402 +9182 4 7.28001 14.6396 19.6917 19.816 -24.9044 7.79538 +9183 6 19.8038 0.841082 24.7751 2.23798 25.7663 18.7115 +9184 4 19.2888 0.974936 25.5977 -1.44078 2.26272 -14.328 +9185 4 20.345 1.66892 24.688 -12.1486 -28.8133 2.35345 +9186 6 3.00622 10.0987 2.94957 -26.3714 23.4248 -9.90714 +9187 4 2.57802 10.9845 2.80681 8.85648 -28.8297 5.38 +9188 4 3.90714 10.2978 3.18407 20.8138 3.7803 5.2 +9189 6 15.8735 13.0135 24.0167 27.3456 -6.4848 -7.35342 +9190 4 15.0397 13.4574 24.067 -14.2007 12.8972 1.61729 +9191 4 16.3075 13.2711 24.8409 -0.511489 -7.63656 -0.0548578 +9192 6 17.0843 4.34635 26.9246 21.6007 -4.50946 14.2865 +9193 4 16.8972 4.2188 26.0046 2.50265 0.324122 -20.691 +9194 4 18.0611 4.2338 26.9976 -18.2314 5.96709 -0.11875 +9195 6 33.6189 39.4094 10.6341 -20.462 51.0085 -28.6484 +9196 4 33.9391 38.663 11.0702 20.9333 -51.253 8.17882 +9197 4 33.8334 39.409 9.67256 -1.15733 -4.02232 18.0774 +9198 6 36.2391 1.10544 13.1071 -14.4853 9.25302 -40.2412 +9199 4 35.5849 0.422507 13.2928 -0.138393 -8.38057 10.5121 +9200 4 36.8138 1.26142 13.8363 9.41155 -3.27129 23.8008 +9201 6 40.853 19.2974 5.10856 37.2457 -28.9827 71.4026 +9202 4 40.5429 19.587 4.3016 -40.6732 16.7295 -57.0845 +9203 4 40.1307 19.0416 5.7147 0.644924 10.2678 -10.4268 +9204 6 2.34714 37.5568 10.1845 35.9634 7.02123 17.8242 +9205 4 3.04769 37.1203 10.7322 -14.847 6.26565 -12.1612 +9206 4 1.86424 36.8893 9.71962 -14.8151 -24.6966 -11.8987 +9207 6 8.10127 29.0413 15.8656 35.302 -29.7249 12.8686 +9208 4 9.00843 28.6191 15.9508 -31.5464 15.4715 -14.0583 +9209 4 8.16404 29.7921 16.4466 -1.11054 13.1495 4.82257 +9210 6 47.3142 26.5199 12.5393 12.6514 34.6971 -22.5506 +9211 4 47.5805 27.2834 11.915 -17.373 -39.4708 28.4474 +9212 4 47.3752 25.7188 12.0092 -0.907674 -0.00416251 -5.94845 +9213 6 33.5917 17.5154 0.659811 -43.6991 -50.8046 22.4668 +9214 4 32.6165 17.4611 0.916402 33.9721 22.4374 -10.1482 +9215 4 33.8023 16.5556 0.790839 15.7196 25.0769 -8.55135 +9216 6 38.9785 15.6005 36.3846 -2.2974 -5.19358 -9.56289 +9217 4 39.1604 14.6481 36.4599 -0.972636 7.263 -3.41001 +9218 4 39.314 15.9159 35.5329 5.29716 -3.31476 -2.44888 +9219 6 34.8185 34.3512 9.36223 6.47638 -43.1481 -28.0847 +9220 4 35.4473 34.9875 9.0418 9.26483 22.2324 -9.2882 +9221 4 34.4241 34.6992 10.1221 -17.9819 29.7233 40.2724 +9222 6 44.963 2.56985 14.7807 31.4374 15.1132 5.36654 +9223 4 44.0324 2.49792 14.9225 -24.9873 -3.38313 6.1219 +9224 4 45.264 3.39221 15.2058 -8.16761 -2.00961 -7.57881 +9225 6 42.6004 38.2794 19.8329 35.0217 22.8895 -33.2683 +9226 4 42.7468 39.1886 19.4383 -9.39889 -30.5105 9.50416 +9227 4 43.174 37.7101 19.2395 -23.2435 10.9907 19.5876 +9228 6 18.6884 26.768 30.2631 -44.5574 -6.69712 -17.565 +9229 4 18.1049 26.7773 29.4546 19.8507 -1.43152 25.0232 +9230 4 19.5658 26.9377 29.9555 24.8572 5.14496 -8.76909 +9231 6 38.8622 37.7231 16.4658 -22.8479 4.5656 13.1257 +9232 4 38.7902 36.7734 16.2818 1.44729 8.74588 -1.32739 +9233 4 39.7766 37.9619 16.5567 26.2519 -3.67716 3.06508 +9234 6 49.2941 9.82087 12.5338 42.2108 35.2088 45.7943 +9235 4 48.9089 9.29765 11.888 -36.0338 -29.0733 -40.4243 +9236 4 48.6148 10.195 13.1058 -6.01968 0.395602 -5.44143 +9237 6 43.2224 7.37144 19.82 -8.13737 3.26926 23.5272 +9238 4 42.5007 7.77471 20.3735 21.5488 -7.79487 -11.5807 +9239 4 44.0862 7.49788 20.2643 -6.92785 0.102081 -4.68832 +9240 6 36.344 38.7219 4.42923 6.60518 -8.27287 -3.54737 +9241 4 36.8681 39.515 4.62823 -9.591 -1.38231 4.53716 +9242 4 35.4251 38.8858 4.67742 1.90858 4.69501 2.45497 +9243 6 27.7906 17.7903 15.1063 3.75124 -7.8529 -14.6222 +9244 4 27.6041 16.8818 14.7764 0.112743 20.8749 5.00331 +9245 4 27.89 17.7299 16.0573 -1.67078 -3.69001 6.73869 +9246 6 18.0934 3.7697 37.3166 -37.4896 -7.94699 -19.9181 +9247 4 18.6099 3.0373 36.9676 7.8944 1.98274 4.30106 +9248 4 18.6508 4.23334 37.9126 25.9725 10.5984 22.5053 +9249 6 7.70643 11.5866 6.5218 3.89219 -35.3855 26.5153 +9250 4 7.81247 12.3986 6.99593 -0.830342 19.7116 4.35361 +9251 4 7.69429 11.7375 5.59555 -1.18048 8.56411 -33.1609 +9252 6 31.493 14.3493 18.0362 -8.33789 -14.4781 24.6772 +9253 4 32.1359 14.6991 17.4236 11.1505 2.18599 -11.6706 +9254 4 31.9992 13.8221 18.6877 -1.72215 8.99473 -5.41338 +9255 6 50.3257 30.4119 8.91981 13.6638 2.66477 0.921327 +9256 4 49.6699 30.7962 8.33415 -6.09837 5.9585 -1.44957 +9257 4 50.0726 29.5063 9.09532 -3.6785 -2.74239 1.52637 +9258 6 42.1666 10.1001 12.7665 27.8846 0.568566 -7.78474 +9259 4 41.2574 9.89168 12.6212 -25.0269 -7.71108 -1.23548 +9260 4 42.2044 10.927 13.2385 -4.76175 6.29789 8.61568 +9261 6 37.7726 3.10257 32.5651 17.7286 -33.908 -11.3576 +9262 4 38.1655 3.96622 32.6549 -5.80606 19.6252 0.391082 +9263 4 36.8286 3.11418 32.7073 -14.5698 15.7581 5.48125 +9264 6 35.7529 13.1025 19.269 15.6222 -22.7979 5.95892 +9265 4 36.108 13.8438 19.7616 3.89933 6.86159 4.70877 +9266 4 36.3275 12.3403 19.5267 -16.9537 12.3267 -5.61016 +9267 6 45.5307 4.12701 21.4866 3.53751 -14.4086 10.8893 +9268 4 45.552 4.15257 20.5178 1.20389 1.85135 1.62688 +9269 4 45.7304 3.20168 21.7391 -1.66454 15.9633 -13.005 +9270 6 16.8818 1.84763 31.4809 -38.7514 34.7723 -17.791 +9271 4 16.1373 2.3559 31.0688 16.7124 -32.2776 -3.52377 +9272 4 16.9707 2.38347 32.2636 22.4894 -8.71684 18.7287 +9273 6 14.088 4.88632 23.5804 12.6338 -46.5447 -4.7054 +9274 4 13.8705 5.7909 23.7155 -14.7558 31.001 11.1078 +9275 4 13.7332 4.31383 24.2952 -4.17517 18.1368 -8.36436 +9276 6 38.3179 33.7515 12.3711 -25.6361 -5.15185 -28.4625 +9277 4 38.1256 32.9508 11.8227 6.04426 17.9062 13.2724 +9278 4 39.1779 33.654 12.756 21.0695 -5.21903 12.1581 +9279 6 35.6902 3.04562 37.6746 -3.39904 8.35156 -7.25132 +9280 4 35.0929 2.54933 38.2324 -5.1037 -10.0227 3.00486 +9281 4 35.8394 3.86187 38.1597 5.81883 9.20211 1.39187 +9282 6 31.3375 37.3986 35.3773 -3.71028 -11.6357 31.0668 +9283 4 32.2621 37.6229 35.4422 12.7398 8.80293 9.59752 +9284 4 31.1956 37.5429 34.4696 -8.56261 0.879722 -41.7472 +9285 6 52.0699 11.7425 14.0188 13.7235 -2.71131 -30.9774 +9286 4 51.8967 11.0942 13.2788 12.7756 18.36 20.3091 +9287 4 52.777 12.3878 13.7226 -29.9657 -23.6346 9.26958 +9288 6 26.3494 3.44143 41.0133 25.155 -37.875 16.6614 +9289 4 25.5593 3.94137 41.1232 -17.1598 23.2709 -17.7277 +9290 4 26.8278 3.58917 40.1822 -8.59815 12.7626 -4.44352 +9291 6 24.371 34.9599 11.1571 26.4033 32.6711 -2.50587 +9292 4 24.3639 34.5741 12.011 0.42503 -6.32387 38.1824 +9293 4 23.9976 34.2869 10.6415 -25.866 -31.4028 -29.8537 +9294 6 32.0031 7.59722 31.2247 -0.72006 7.33901 18.8157 +9295 4 32.1508 7.36357 30.327 0.345644 0.817488 -27.7554 +9296 4 31.6126 8.48818 31.2118 -2.13527 -8.40442 2.30992 +9297 6 28.7291 2.6069 0.424694 -24.9548 -1.7826 -18.2237 +9298 4 29.2265 2.34055 41.548 2.55638 3.32464 9.52498 +9299 4 27.7798 2.59721 0.142899 25.7986 3.33204 9.63582 +9300 6 42.1267 19.2107 9.86358 19.9254 -1.00598 31.807 +9301 4 42.7282 19.2504 10.675 -28.0191 -3.63038 -32.4782 +9302 4 41.4654 18.506 9.99331 2.41107 5.70909 -2.24499 +9303 6 33.0117 27.0899 8.33041 6.96541 -9.8522 -22.9567 +9304 4 33.8754 26.9804 7.88875 -4.89246 2.6856 6.68054 +9305 4 33.1889 27.2976 9.23992 7.88062 7.04275 14.0068 +9306 6 4.17016 8.31297 19.162 0.312608 -23.727 -31.8356 +9307 4 4.57057 7.90515 18.3575 7.98956 13.418 22.158 +9308 4 3.24181 8.25888 18.9046 -6.31749 7.79174 9.16769 +9309 6 20.797 29.1851 37.0682 -78.8245 -16.0462 -5.4556 +9310 4 20.936 28.2326 36.9784 16.4861 -0.723813 3.66436 +9311 4 21.5674 29.6886 37.0761 54.0195 18.5923 4.39527 +9312 6 13.113 4.99943 10.9253 0.843453 12.9862 -7.21248 +9313 4 13.3812 5.91092 11.1622 0.48683 -16.0572 0.936043 +9314 4 12.7752 5.03128 10.0238 -4.21215 6.55392 -0.64752 +9315 6 37.5015 18.1018 32.5195 21.2703 25.6519 14.9603 +9316 4 38.1786 18.7738 32.2234 -25.3038 -17.5123 8.13315 +9317 4 37.1867 18.4103 33.3985 6.70568 -0.056708 -13.7279 +9318 6 17.7491 33.2689 30.7387 4.64458 14.8517 -20.1826 +9319 4 17.8421 33.9996 30.1068 1.39741 -2.79987 6.34018 +9320 4 18.5541 33.2627 31.2599 6.50121 5.74528 2.59283 +9321 6 23.1871 32.777 9.90494 7.13269 10.4795 -4.3903 +9322 4 23.4604 31.94 10.2921 1.41378 -5.3263 0.807867 +9323 4 22.2339 32.7251 9.74224 0.938735 -0.283076 -0.953242 +9324 6 14.8916 9.36878 34.2544 -3.17606 -9.25219 -4.09189 +9325 4 15.4257 8.57154 34.1751 4.23415 -4.52565 -0.814207 +9326 4 15.1936 9.94604 33.5417 3.33837 13.7034 4.88209 +9327 6 31.123 39.3556 38.5725 10.4581 -15.7875 9.507 +9328 4 31.6408 38.6334 39.0195 -17.0405 19.4438 -10.5616 +9329 4 30.3963 38.9123 38.1137 2.26745 0.847431 0.999129 +9330 6 5.28935 34.441 28.2777 -1.85934 -10.7383 -20.8922 +9331 4 5.27738 35.3973 28.3959 -1.64374 -0.931958 4.82044 +9332 4 5.15855 34.3195 27.3212 3.56171 0.206479 13.9304 +9333 6 30.3161 21.6889 14.1169 -2.08187 28.5408 26.4102 +9334 4 30.4824 20.7856 14.3415 3.20532 -20.0191 -7.60805 +9335 4 30.3589 21.8902 13.1869 1.55029 -10.1196 -17.5522 +9336 6 23.85 39.0046 28.2977 69.4329 26.2515 4.57453 +9337 4 23.9916 39.6084 27.5499 -13.57 2.08121 2.63988 +9338 4 23.036 38.5875 28.2612 -60.5143 -23.8938 -11.8576 +9339 6 9.59742 13.5396 16.4589 33.261 19.9292 -8.86772 +9340 4 8.78625 13.0496 16.3926 -14.9619 -4.96746 -5.567 +9341 4 9.78335 13.9533 15.5888 -9.09133 -14.4247 9.50074 +9342 6 25.9705 6.17968 15.7985 42.799 -23.1477 28.9675 +9343 4 26.019 6.01901 14.8637 -2.75181 4.35539 -17.3872 +9344 4 26.7603 5.64791 16.135 -36.9143 25.7793 -10.0513 +9345 6 15.9952 33.6108 22.5498 -1.32684 21.179 0.174096 +9346 4 16.0845 34.132 21.7265 -5.08009 -17.3545 9.33233 +9347 4 16.0452 32.6693 22.2946 2.44519 21.8582 -2.86748 +9348 6 40.6954 13.5457 12.1293 -5.68603 3.79069 10.9638 +9349 4 40.3939 13.0592 11.3555 -1.07855 -14.0058 -3.54454 +9350 4 41.0539 12.9031 12.7626 -3.06611 3.62129 -5.67307 +9351 6 35.5822 40.2773 31.6862 -1.2862 -13.706 14.6905 +9352 4 36.0451 40.9783 31.2154 -1.32327 -4.34646 -14.1397 +9353 4 35.653 39.3915 31.2603 0.648621 22.1552 -3.29488 +9354 6 19.3539 17.5757 17.8527 24.8545 64.4629 -5.36553 +9355 4 19.9703 18.4106 17.9379 -31.776 -45.1138 0.798127 +9356 4 18.7059 17.8424 17.1823 2.41282 -7.28307 3.58563 +9357 6 7.95249 28.0742 10.7793 26.3782 25.043 4.49745 +9358 4 8.50313 28.8396 11.0908 -15.1612 -19.5627 1.83511 +9359 4 7.20779 28.4792 10.322 -5.34026 -2.34355 -4.06419 +9360 6 32.1473 39.5951 16.6478 -17.9563 1.55165 -8.91142 +9361 4 31.6569 40.3908 16.3404 14.2892 -12.9666 6.03874 +9362 4 31.5266 38.8716 16.4637 6.06753 4.48602 8.64925 +9363 6 35.7883 2.63292 18.1275 9.48574 -34.9606 14.0071 +9364 4 34.8666 2.32593 18.1793 13.7366 6.70894 -2.41967 +9365 4 35.7792 3.51083 17.8116 -6.62646 29.9084 -15.3578 +9366 6 14.9404 39.9496 36.887 -3.95865 -34.2615 35.0372 +9367 4 15.4649 39.4425 36.2826 11.0028 -6.45738 -16.6057 +9368 4 15.0284 40.8419 36.6608 5.56286 51.7396 -15.8162 +9369 6 18.3052 32.4025 11.469 7.68428 8.43447 19.219 +9370 4 18.6311 32.5236 12.4045 -8.3236 -1.07971 -30.5152 +9371 4 17.8613 33.2392 11.223 7.02035 -14.738 0.639166 +9372 6 14.6021 10.381 5.00501 12.904 -5.64335 9.41677 +9373 4 13.6938 10.4305 4.69945 -10.3065 0.63937 1.1744 +9374 4 14.613 10.0418 5.92181 -1.23128 6.20644 -15.3767 +9375 6 2.02771 14.3355 39.1727 -5.84559 30.0988 4.34298 +9376 4 2.70173 15.0418 39.0898 -4.78946 -14.8923 5.30178 +9377 4 1.28797 14.7602 39.6738 10.0694 -17.377 -15.1558 +9378 6 7.58332 14.1556 32.4652 3.8824 27.7869 10.7592 +9379 4 6.9433 13.665 32.9756 -4.43494 -6.18284 1.69377 +9380 4 7.54129 15.0698 32.8492 6.23928 -24.1467 -15.6449 +9381 6 6.15722 23.1341 37.6504 -34.5618 -50.1938 -2.0692 +9382 4 6.56488 23.96 37.7745 13.4151 41.4847 -0.267706 +9383 4 5.38195 23.2242 37.0516 20.9526 5.02196 8.70483 +9384 6 37.2952 22.537 4.44472 51.3933 75.9823 3.75371 +9385 4 36.5074 22.1342 4.18978 -47.7056 -22.8011 -17.3868 +9386 4 37.221 23.5361 4.21623 -3.53185 -51.7458 12.1203 +9387 6 47.1368 31.0168 5.89375 -14.3926 17.1884 -69.1718 +9388 4 46.9718 30.7968 6.77028 -10.6218 -7.91998 56.0799 +9389 4 46.2684 31.351 5.53353 23.0456 -16.9797 4.17914 +9390 6 54.8109 25.5937 34.9376 16.0179 27.3393 -6.0446 +9391 4 54.0726 25.4665 35.5517 -1.08617 7.29827 -2.61058 +9392 4 0.161491 26.54 35.0366 -21.9365 -36.0956 3.57937 +9393 6 37.1499 2.07739 4.80452 -1.94348 22.0087 -45.3652 +9394 4 36.668 2.89852 4.54683 5.06511 -19.4283 11.9563 +9395 4 37.1062 1.96831 5.73813 -4.74438 -1.19387 27.2393 +9396 6 22.5142 28.609 8.91066 14.7838 -0.767913 33.3492 +9397 4 22.9803 28.3541 9.73828 -15.565 12.7605 -7.61321 +9398 4 22.8168 27.9481 8.31925 3.93055 -13.9923 -25.0246 +9399 6 8.64284 27.1533 24.5627 -30.3364 66.7798 9.61681 +9400 4 7.68564 27.0552 24.6389 4.16714 -15.7471 -5.05425 +9401 4 9.10482 26.3676 24.4825 22.9633 -64.4218 -6.53839 +9402 6 1.14841 23.7276 2.43845 3.37143 2.75553 -28.3576 +9403 4 1.24451 23.8913 1.47114 -2.40676 3.6179 20.3541 +9404 4 0.297784 23.2877 2.48462 -2.13531 -2.42607 6.29474 +9405 6 54.3749 30.2279 27.0351 -1.87188 5.01086 -25.6864 +9406 4 54.247 29.4439 26.4851 0.283672 1.58093 2.67322 +9407 4 54.589 30.9178 26.3677 -1.31459 -2.18642 16.2549 +9408 6 0.382292 8.43516 23.9819 16.8945 -11.9539 9.7221 +9409 4 1.32445 8.60369 24.1565 -2.20413 -11.2301 -8.89161 +9410 4 54.9553 8.73001 24.7921 -9.77823 11.7559 2.768 +9411 6 16.9131 28.5848 33.3683 -2.23593 -25.3201 -21.0962 +9412 4 17.3654 28.7863 34.1955 9.02781 -2.88055 -0.915496 +9413 4 17.3951 27.8627 32.8656 -13.2947 27.9561 26.4245 +9414 6 33.6945 30.8881 0.140848 11.5734 5.16226 7.65985 +9415 4 34.5903 30.4955 0.196618 -6.50407 7.83028 -3.90982 +9416 4 33.2725 30.4522 41.313 0.902851 -8.5209 -4.03004 +9417 6 16.2572 21.5133 34.1618 -1.32279 -12.2579 -0.0768877 +9418 4 15.8666 20.7686 33.6578 14.5936 10.7995 5.0381 +9419 4 16.7742 21.1109 34.8905 -13.5083 8.43335 -11.1581 +9420 6 0.208862 17.804 35.7536 -14.601 -29.9007 -2.72034 +9421 4 54.2286 17.807 35.5323 33.4083 9.0609 14.8615 +9422 4 0.362977 16.9429 36.1939 -0.60553 13.4006 -6.21859 +9423 6 16.8205 12.2987 0.018055 22.2965 10.2312 29.8095 +9424 4 17.2696 12.8062 0.753963 -11.4311 -8.71934 -28.0399 +9425 4 16.617 11.4478 0.422257 -11.1364 1.3302 -4.58262 +9426 6 8.24969 9.53941 36.253 -15.0171 13.8578 -6.15226 +9427 4 7.92627 8.96163 36.9484 -10.0154 -4.61382 -0.313479 +9428 4 7.46687 9.9886 35.83 14.4541 -3.15884 14.1629 +9429 6 48.5699 26.7153 39.8372 -6.05787 -6.72914 15.0837 +9430 4 48.3449 26.8926 38.9385 -16.4424 3.29077 -18.6566 +9431 4 49.4571 27.0352 39.8842 23.4859 3.73228 5.76721 +9432 6 35.4844 1.07048 23.1169 11.4549 30.8088 37.1655 +9433 4 36.0158 1.76714 22.6808 -9.17201 -14.7916 0.90361 +9434 4 35.6328 1.27141 24.1103 0.373025 -19.0496 -44.6811 +9435 6 20.2784 30.6315 19.3752 23.9103 -21.6662 15.3888 +9436 4 20.3116 31.0532 20.259 -5.42732 -3.95571 -8.57186 +9437 4 20.9344 29.8759 19.4191 -22.0709 25.9102 -5.54449 +9438 6 44.3706 15.9499 1.58551 5.68582 14.4456 12.9619 +9439 4 44.3685 15.5676 2.49167 2.87795 14.7015 -16.764 +9440 4 44.6274 16.9163 1.6094 -6.5628 -31.3198 6.45039 +9441 6 53.8881 34.4681 10.5864 -33.0496 11.7448 -26.9592 +9442 4 54.422 34.2751 11.3149 32.4161 -9.35278 40.7994 +9443 4 54.2788 35.2396 10.1584 -0.0979649 -6.0993 2.73708 +9444 6 46.1388 32.8516 33.5211 5.22207 -15.0187 3.22626 +9445 4 45.9452 33.6327 33.0044 -1.75723 11.2428 -3.91525 +9446 4 47.0422 32.5752 33.2841 -5.1447 4.42718 0.252344 +9447 6 42.1248 21.9061 24.225 29.3467 -8.59285 14.1471 +9448 4 43.0897 21.6191 24.2618 -39.2895 4.06832 7.69751 +9449 4 41.7308 21.6944 25.1042 13.707 1.91177 -18.5137 +9450 6 8.13464 3.90485 11.6471 19.3767 -1.70453 -18.8264 +9451 4 7.33962 4.19894 12.0861 -8.05938 -6.79837 10.6821 +9452 4 8.35918 3.01511 11.9412 -4.68297 1.80025 9.46807 +9453 6 19.6422 41.6776 9.83213 -10.6455 12.1827 13.5714 +9454 4 18.8651 41.1405 9.66265 4.99962 -3.76564 -7.41899 +9455 4 19.3487 0.264237 10.6212 9.02518 -11.5641 -14.6522 +9456 6 42.3073 8.42404 31.6799 28.9247 6.2763 -10.2166 +9457 4 41.4386 8.38933 32.0551 -18.7028 2.48038 0.978172 +9458 4 42.5266 9.37939 31.5704 -3.99861 -19.3235 1.7837 +9459 6 26.9144 16.155 25.3557 3.37886 4.46922 -29.1574 +9460 4 26.8932 15.8089 24.4276 -4.09623 14.1183 21.5023 +9461 4 26.5944 15.4425 25.8888 -2.2842 -17.5105 15.3426 +9462 6 48.2339 6.48607 12.6213 -2.32796 -4.32122 -9.13051 +9463 4 48.9884 6.29985 12.0375 -6.36801 1.93824 2.64233 +9464 4 47.4521 6.15437 12.1363 8.14441 0.739204 7.03502 +9465 6 53.4551 41.5313 30.6545 -6.55363 -20.9747 -16.7061 +9466 4 53.9707 41.8328 29.895 1.38615 3.54438 2.31965 +9467 4 53.5938 0.199493 31.3858 11.9182 14.0856 15.8016 +9468 6 47.0766 22.4304 31.8083 3.49024 11.2606 -9.33253 +9469 4 47.8957 22.458 31.249 -27.0486 7.80914 13.6686 +9470 4 46.5597 23.2507 31.6033 14.3992 -20.3875 6.89099 +9471 6 19.5103 5.43818 15.252 80.4346 7.77941 -36.259 +9472 4 19.9845 4.58151 15.2093 -6.94904 10.3389 3.32724 +9473 4 18.6939 5.26573 15.6196 -64.0069 -9.45641 27.6942 +9474 6 14.6723 30.2358 33.3977 29.3194 14.0021 -15.573 +9475 4 15.2147 30.9127 32.9173 -16.9191 -15.4944 5.99358 +9476 4 15.2716 29.4658 33.3729 -9.39086 7.05787 2.01807 +9477 6 28.44 24.2314 10.4028 3.15123 -12.4056 -9.54268 +9478 4 29.226 24.4262 10.8786 32.4584 2.85658 2.79411 +9479 4 27.8296 24.5485 11.0342 -36.3144 6.15546 12.0187 +9480 6 5.27118 14.4387 24.4945 35.1445 25.2092 -0.0633509 +9481 4 4.43594 14.1516 24.7736 -48.8682 -19.2375 4.52664 +9482 4 5.4685 14.0235 23.6561 -3.04719 -11.4521 -9.99341 +9483 6 26.3524 19.2908 19.1818 20.1263 -20.0506 -24.4735 +9484 4 26.6388 20.1349 19.5116 -1.98461 18.5008 5.62334 +9485 4 27.0961 18.9592 18.5977 -26.1102 9.18548 27.2368 +9486 6 28.5758 7.44193 13.1857 16.8206 36.5977 2.40675 +9487 4 28.4276 6.5743 12.8854 -8.83608 -34.241 -6.14436 +9488 4 29.1296 7.84613 12.4994 -7.23682 2.38597 3.89632 +9489 6 5.36882 27.1473 37.046 11.8823 -4.88323 19.1587 +9490 4 6.08575 26.9595 37.7076 -19.1456 -1.45009 -21.6041 +9491 4 5.36685 28.0942 36.8598 5.86896 -0.355799 -4.60773 +9492 6 53.1378 13.4025 16.0996 34.2435 -3.86055 5.06914 +9493 4 54.0829 13.0966 15.9504 -32.0077 5.91706 2.7318 +9494 4 52.5847 12.6783 16.4422 5.4814 -0.344951 -11.4066 +9495 6 45.452 1.01889 24.6154 3.31322 11.7394 9.54943 +9496 4 44.8157 0.989703 23.8982 -3.33354 -4.25493 -1.52857 +9497 4 44.9019 0.844105 25.4008 9.82267 -2.51687 -6.81685 +9498 6 50.1641 2.37547 13.9256 -5.79196 7.9049 4.59273 +9499 4 50.7992 2.78767 13.3238 -3.84891 -0.754592 0.637936 +9500 4 49.4746 3.0334 14.0873 2.34893 4.7321 -2.13859 +9501 6 19.5803 31.0161 39.1628 -18.0613 -25.9328 -11.5794 +9502 4 19.7424 30.2951 38.4816 -0.347779 24.7736 22.083 +9503 4 18.6224 30.9377 39.4182 28.2801 4.19594 -11.375 +9504 6 19.2561 14.7051 10.8744 35.9018 -50.5273 5.13524 +9505 4 20.0412 14.097 10.5737 -45.0165 49.548 5.48727 +9506 4 18.7602 14.0269 11.3662 -4.16951 16.5755 -2.6658 +9507 6 4.45594 39.5485 20.1375 -7.26247 21.8372 28.3356 +9508 4 3.95576 40.4005 20.2782 15.6699 -22.2203 -5.74536 +9509 4 4.87483 39.3065 21.0019 -15.4768 4.14169 -24.4646 +9510 6 29.0152 13.3442 23.91 8.01267 35.4951 15.4816 +9511 4 28.7225 12.4574 23.7464 -4.82052 -12.6612 5.31893 +9512 4 28.8407 13.5397 24.8723 9.679 -4.85246 -32.6651 +9513 6 17.068 2.76349 17.6602 17.5731 -10.7754 -19.6116 +9514 4 16.9152 3.43747 16.9733 0.569879 -2.90947 3.06519 +9515 4 17.8166 2.20316 17.3149 -21.6663 12.1671 7.12297 +9516 6 43.4725 18.0406 17.7144 -1.44781 -24.3706 15.3127 +9517 4 43.4291 17.0524 17.7495 6.1749 24.1268 -14.107 +9518 4 43.576 18.2305 18.6573 0.474252 7.4982 -2.94392 +9519 6 25.7765 40.7491 1.25834 -5.13784 -8.67992 -41.8469 +9520 4 26.3241 41.1434 1.92597 2.9618 17.1891 5.50682 +9521 4 25.7331 41.3641 0.469204 -4.81559 -13.5206 29.0343 +9522 6 0.465549 22.8917 6.22214 -2.55797 -7.94984 -3.9446 +9523 4 0.971697 22.1453 5.8424 -8.20264 3.34524 4.91565 +9524 4 1.09943 23.372 6.75946 4.60597 5.6548 -4.31438 +9525 6 26.241 35.011 18.6432 -1.36099 17.7753 -9.20742 +9526 4 25.9471 35.9461 18.6768 6.76043 -15.7179 -8.96745 +9527 4 25.6107 34.5957 19.2286 4.79325 -10.2415 3.05652 +9528 6 16.134 31.8742 7.55305 63.3701 -24.5537 -22.1036 +9529 4 16.96 31.3344 7.22221 -43.8871 18.402 28.1533 +9530 4 16.2567 32.6659 7.02685 -6.92396 6.43503 -6.66113 +9531 6 22.9365 16.8424 28.5556 -11.8911 28.7995 -6.03551 +9532 4 23.1131 16.1224 27.957 -2.92592 -13.6094 -7.1053 +9533 4 22.1672 17.3806 28.2048 22.5292 -24.3034 15.5849 +9534 6 48.8154 29.3426 32.1508 17.6607 -5.63259 25.101 +9535 4 47.9338 29.1776 31.8283 -15.752 -0.354552 -3.67809 +9536 4 48.876 28.9209 33.0523 -3.3832 13.4569 -22.7771 +9537 6 13.1275 24.861 5.55911 -24.9858 12.0714 -24.023 +9538 4 12.9095 24.1076 4.98414 3.68764 2.77663 3.09454 +9539 4 12.4428 25.5491 5.3163 19.4298 -17.0083 16.84 +9540 6 10.97 20.7168 15.838 25.2219 -21.2413 -18.4662 +9541 4 10.9273 20.4774 14.8836 -9.78471 10.8905 20.232 +9542 4 11.8407 20.3068 16.0784 -25.4832 11.5027 -0.03881 +9543 6 13.8668 18.3675 6.9377 -17.1805 34.1284 -15.5183 +9544 4 13.9861 19.3268 7.07801 0.95534 -8.68107 -9.41428 +9545 4 14.2312 17.9937 7.71618 14.696 -22.4056 21.3209 +9546 6 13.8328 12.9436 30.6366 23.8936 8.4875 1.93436 +9547 4 14.0561 12.5213 29.7889 -15.7862 -10.4805 9.2002 +9548 4 13.0857 12.5134 31.0734 -5.46762 -5.09599 -12.1481 +9549 6 17.1276 6.33232 31.2677 66.6528 76.8842 26.6004 +9550 4 16.7194 7.19542 31.0916 2.25558 -4.54354 -1.53399 +9551 4 16.4872 5.75051 31.0533 -74.7845 -70.3194 -26.0669 +9552 6 7.63688 23.4278 20.549 2.87884 3.81634 -6.68902 +9553 4 7.34623 23.1229 19.6666 2.94756 -0.449201 10.6329 +9554 4 8.04096 24.3016 20.3852 -3.87648 -11.4978 -1.95405 +9555 6 15.5875 36.6622 25.6317 44.8659 35.0544 -6.16252 +9556 4 16.5723 36.6215 25.7443 -25.3852 -14.6967 7.558 +9557 4 15.5456 37.5452 25.2115 -8.92727 -11.7797 -1.50769 +9558 6 0.738994 10.4213 22.1809 -27.1543 -36.2471 -13.1925 +9559 4 0.031346 10.3136 21.4752 22.4259 7.4169 21.1377 +9560 4 0.614162 9.62536 22.7539 0.837437 23.266 -16.3015 +9561 6 33.4753 17.3986 33.5966 50.0322 34.9653 -25.691 +9562 4 33.729 18.3684 33.3861 -23.79 -42.9591 12.1009 +9563 4 34.1104 16.8695 33.0603 -9.99519 5.32569 13.787 +9564 6 21.6594 19.0069 20.7632 22.9673 -17.6764 -6.78691 +9565 4 22.3468 19.6741 20.9606 -3.94962 -13.1079 -1.95693 +9566 4 22.1476 18.14 20.6003 -16.6978 33.0759 6.74927 +9567 6 41.7633 20.003 16.8748 -11.326 -1.31128 -8.84591 +9568 4 42.2034 19.1563 16.9874 6.48398 -7.2756 0.328325 +9569 4 41.4682 20.0367 15.9399 8.87316 5.12137 10.7952 +9570 6 12.0358 14.9766 17.6999 -26.21 -7.2152 -26.0517 +9571 4 11.2991 14.5498 17.1995 11.2858 13.8526 14.1879 +9572 4 12.4764 14.2447 18.105 9.10187 -13.3837 13.9354 +9573 6 23.0147 11.4211 40.7142 -19.9953 11.3897 74.5259 +9574 4 22.9359 12.2968 41.1901 4.60696 -23.5555 -21.1396 +9575 4 23.3157 11.5565 39.857 19.7433 14.0142 -51.5111 +9576 6 21.0056 28.3023 24.5803 -69.1041 85.2373 -40.9106 +9577 4 20.265 28.1264 25.1705 5.37048 -3.26467 3.49678 +9578 4 21.6928 27.7549 24.7451 59.1792 -66.0576 27.8401 +9579 6 19.39 13.7159 31.9239 29.4118 -13.0288 15.1298 +9580 4 18.7661 13.9847 31.2678 -13.3276 3.02657 -9.68553 +9581 4 18.8827 13.5849 32.728 -3.24577 4.6437 7.00982 +9582 6 21.5915 2.84466 24.7134 0.208747 24.5944 -29.04 +9583 4 21.6872 3.18692 23.7998 -4.92058 -5.74628 13.5023 +9584 4 22.4885 2.58061 24.905 3.18231 -12.543 15.1704 +9585 6 11.3458 29.9955 18.8336 12.03 22.8495 18.6886 +9586 4 10.5716 30.5896 18.8018 6.29595 -15.7791 -4.99952 +9587 4 11.9743 30.476 19.4324 -17.0963 -23.9187 -22.0967 +9588 6 14.6495 22.3648 8.3568 42.8177 1.00499 7.23029 +9589 4 14.0031 23.0587 8.53935 2.83958 6.20927 5.13977 +9590 4 15.5993 22.7606 8.33857 -60.0645 -13.0658 0.526795 +9591 6 43.9468 23.6541 17.2812 -2.43742 26.8438 -12.7514 +9592 4 44.7651 23.2701 16.9945 19.1668 -3.91001 -9.18188 +9593 4 43.5028 22.9 17.6346 -11.2125 -8.13016 15.2757 +9594 6 28.0047 25.4978 27.5091 9.49546 -35.4414 -7.32855 +9595 4 27.536 26.3032 27.53 -22.6173 33.7003 2.08289 +9596 4 28.9082 25.7508 27.3241 10.2254 5.98924 0.98151 +9597 6 19.1021 26.8113 33.1456 6.96794 1.44941 -44.6281 +9598 4 19.0009 26.3889 32.2316 6.61058 22.4795 36.193 +9599 4 19.4537 27.7357 32.9996 -8.5054 -25.835 6.12407 +9600 6 6.37601 19.3499 5.67113 -3.07724 -15.511 8.20386 +9601 4 6.68786 20.0294 5.07731 7.18653 8.65774 -7.7972 +9602 4 5.56195 19.7092 6.03854 -2.87224 2.62267 4.46635 +9603 6 37.49 28.403 9.68405 -10.2736 -31.6176 -26.4717 +9604 4 37.8518 27.9475 10.4351 5.1765 10.0485 19.5132 +9605 4 37.3493 27.6251 9.09625 -2.69325 25.3221 7.01666 +9606 6 17.6998 27.0953 11.7898 -36.7906 -34.4972 13.5582 +9607 4 17.0141 26.488 11.3694 25.6316 27.0728 3.78529 +9608 4 17.4298 27.07 12.7376 6.94557 14.4563 -18.9236 +9609 6 12.8888 1.93962 24.1529 -50.3802 38.9184 -15.728 +9610 4 12.0235 2.45928 24.1313 32.0413 -19.6529 -17.3906 +9611 4 12.9222 1.7892 25.0724 13.055 -19.4335 33.1456 +9612 6 27.8476 37.1183 33.3015 17.2618 -5.56645 -20.6455 +9613 4 27.8725 37.7306 32.5366 -3.66202 -8.07766 15.1749 +9614 4 28.4268 36.3488 33.0405 -13.8477 22.6944 8.61763 +9615 6 18.6736 12.3707 6.31908 6.91225 -31.4632 27.4828 +9616 4 18.6995 11.385 6.25383 -9.67628 20.7874 -2.26223 +9617 4 18.5836 12.6888 5.4344 -4.12511 6.2973 -26.1687 +9618 6 10.1784 29.305 24.7735 -9.10204 -23.9111 21.4033 +9619 4 10.6991 28.9855 25.5395 2.35147 16.2142 -6.30056 +9620 4 9.48939 28.598 24.7147 15.6456 22.7499 -9.47694 +9621 6 7.25796 3.28933 16.2737 -3.06701 21.6066 -7.53298 +9622 4 7.8017 4.02386 16.6541 -5.18893 -18.6288 5.77884 +9623 4 6.83195 2.7267 16.9458 19.6595 6.39335 -0.783342 +9624 6 32.1965 37.5589 1.11244 17.7564 -13.393 -49.4834 +9625 4 31.8113 36.9118 1.6863 -14.8068 -2.94474 23.9511 +9626 4 32.3136 38.4192 1.49585 -8.3749 16.0852 25.1081 +9627 6 10.4319 10.1504 6.4166 -7.63199 8.14139 10.6713 +9628 4 9.50403 10.3698 6.52583 -9.38347 6.87647 -8.77798 +9629 4 10.8186 10.5343 7.22249 5.92406 -9.68277 -8.25616 +9630 6 16.1813 23.2506 37.3799 25.1097 11.6639 -4.85114 +9631 4 16.5396 23.4181 38.2693 -7.5274 5.30939 -3.10176 +9632 4 16.7237 23.8262 36.781 -18.6662 -9.83464 11.0165 +9633 6 24.0859 14.3313 36.5421 -9.86516 7.30801 -0.382215 +9634 4 25.0278 14.1902 36.5644 12.4097 -8.07045 3.76472 +9635 4 23.7255 13.9571 37.3615 2.98939 6.5027 1.55174 +9636 6 27.4763 18.5532 28.7891 -13.5271 -4.91773 7.22809 +9637 4 27.279 18.1935 29.6763 -0.617381 3.48163 -16.8994 +9638 4 26.6639 18.4733 28.2428 3.34183 3.33207 10.806 +9639 6 51.5601 10.4909 1.56577 -57.9967 -14.5533 -18.7957 +9640 4 50.8004 9.99697 1.98849 19.2905 21.9947 -18.6033 +9641 4 52.233 10.462 2.20044 35.6887 -2.31897 35.1783 +9642 6 31.1159 39.6224 27.5035 10.1927 26.9633 6.19817 +9643 4 30.6636 39.3812 28.2975 -12.6206 -22.2416 8.82104 +9644 4 31.2642 40.5609 27.7597 6.49383 -23.2522 -24.0775 +9645 6 6.91312 35.9708 14.3252 -31.0555 -15.8542 22.3873 +9646 4 7.60399 36.2341 13.7609 26.7748 16.1612 -20.4248 +9647 4 7.14109 35.0698 14.5861 -2.88708 -0.858877 1.78829 +9648 6 45.5543 7.568 29.1737 -25.5302 -4.16762 -2.13202 +9649 4 44.8976 7.53234 28.4293 19.2773 0.699039 20.3251 +9650 4 45.0852 7.16669 29.9393 6.23602 2.26061 -10.7804 +9651 6 31.3622 20.562 31.6184 9.65463 4.63597 0.319717 +9652 4 31.8498 21.4034 31.7895 1.14978 -23.5084 -11.6884 +9653 4 31.8627 19.9392 31.0494 0.180852 16.2895 10.8054 +9654 6 43.0328 31.1512 10.3804 -22.1718 15.2565 33.5805 +9655 4 42.075 30.8844 10.4741 26.7443 4.92622 -3.29861 +9656 4 43.2631 31.5811 11.2548 -4.68507 -19.1463 -31.4268 +9657 6 50.935 25.5526 12.6381 -53.0362 -11.2381 37.5759 +9658 4 50.8444 26.3707 12.1889 6.26198 32.0523 -21.5557 +9659 4 51.7606 25.1556 12.4927 46.8244 -9.35474 -8.90879 +9660 6 29.329 2.97736 3.64421 22.5456 -43.1143 -6.52899 +9661 4 29.5843 3.84773 3.82541 15.3974 46.6652 11.4603 +9662 4 28.3975 3.01514 3.57252 -35.3193 1.84796 -10.7817 +9663 6 53.9306 32.0952 20.3602 -26.044 3.42844 6.98601 +9664 4 54.8587 32.2554 20.2589 13.6369 -3.90514 -8.57062 +9665 4 53.586 31.7345 19.5218 3.48091 2.50952 8.05406 +9666 6 41.7156 29.5544 6.48768 19.5894 27.0766 -19.1548 +9667 4 40.8143 29.536 6.19581 -21.1406 0.0261655 0.681639 +9668 4 42.121 30.2839 5.93213 -7.9284 -21.0777 21.5612 +9669 6 37.8354 24.5725 39.3073 -0.786614 -2.83003 -8.48557 +9670 4 37.3057 24.1981 38.5867 -0.305281 2.91934 11.1175 +9671 4 37.4479 24.2715 40.1417 -1.64355 1.86967 -5.36783 +9672 6 46.558 27.5785 23.289 -39.9634 -64.6481 11.0379 +9673 4 46.4646 27.3918 24.2576 6.74558 16.0433 -18.2165 +9674 4 45.9199 26.8188 22.9475 37.5572 46.869 6.09964 +9675 6 9.22773 27.2022 8.33468 -36.26 12.7871 28.7267 +9676 4 8.91275 27.6129 9.1801 5.62558 -9.89589 -23.2096 +9677 4 10.1414 27.0456 8.46037 35.2783 -3.07459 2.5747 +9678 6 36.0491 34.1608 13.9867 7.26402 -14.0442 8.68546 +9679 4 35.9913 33.1738 14.0461 -7.39622 22.1346 -4.41017 +9680 4 36.7548 34.3393 13.3524 -0.0889916 -4.95725 -2.25698 +9681 6 51.6742 14.4867 12.321 25.1613 25.5512 -24.4042 +9682 4 52.0989 14.4284 11.4335 -6.19684 -3.38259 22.4379 +9683 4 51.9807 15.3554 12.6493 -12.3863 -19.4348 1.31199 +9684 6 15.2583 19.6409 32.4144 29.0083 -20.2623 -33.8133 +9685 4 15.2558 19.2688 31.4922 3.04968 7.12699 22.6875 +9686 4 14.3622 19.8256 32.5802 -41.1763 4.86179 8.56209 +9687 6 27.6812 24.6569 38.3606 -19.0318 -31.8029 -32.3422 +9688 4 27.9736 25.1472 39.0974 14.6808 26.4307 29.745 +9689 4 28.3717 24.6185 37.6939 9.13491 6.22605 4.36089 +9690 6 37.5205 9.26898 13.6241 11.458 -4.07639 -2.41324 +9691 4 37.986 8.73412 14.2818 -4.17908 -1.66932 4.91722 +9692 4 37.422 10.1332 14.0472 -5.80925 -1.58022 -1.38856 +9693 6 20.8962 33.2419 26.2614 5.37543 12.855 -2.41316 +9694 4 21.3204 33.4412 27.1125 -5.30181 -3.15861 -4.46659 +9695 4 20.9369 32.3076 26.1263 8.87353 -20.0108 1.20924 +9696 6 6.59104 13.9455 35.2329 -26.8274 -4.60486 4.58094 +9697 4 6.38745 12.9897 35.2457 11.7642 5.99643 -3.17645 +9698 4 7.53507 14.0926 35.2395 12.5421 -8.77428 2.26249 +9699 6 10.0726 7.48467 6.8792 2.12641 6.95589 -11.9404 +9700 4 9.21804 7.15917 6.5645 -4.80657 -1.75614 5.47812 +9701 4 10.1222 8.42177 6.5916 5.16955 -15.159 7.51812 +9702 6 31.1977 5.95154 11.4339 24.7603 28.3677 15.6689 +9703 4 31.4296 6.16733 12.4018 -4.97657 -8.97631 -41.3224 +9704 4 31.9131 6.32779 10.8565 -11.9651 -11.6794 24.5691 +9705 6 12.1328 3.85103 35.2933 -10.0815 -12.0493 27.5499 +9706 4 12.7851 4.21657 34.7189 20.4312 8.87509 -12.0205 +9707 4 12.5123 3.89786 36.1903 -2.36263 6.36147 -16.6701 +9708 6 5.35168 6.07805 27.6549 3.96089 -18.0524 46.6648 +9709 4 5.01336 6.85569 28.0965 2.16186 8.49085 15.9688 +9710 4 5.1377 6.25223 26.7855 -7.5711 11.2001 -66.4514 +9711 6 13.1382 33.574 1.68419 20.6109 34.6607 2.95503 +9712 4 12.5953 33.0967 1.0817 -13.6453 -8.09858 -18.4215 +9713 4 13.3822 34.4502 1.26439 -11.0211 -27.5174 16.1165 +9714 6 44.6427 10.3996 29.0359 8.91116 23.4714 -13.18 +9715 4 44.4953 9.45294 29.0952 0.434286 -4.87704 -7.20081 +9716 4 44.1618 10.7755 28.2587 -0.00111917 -13.6507 16.636 +9717 6 9.15295 24.5944 6.37753 4.35763 15.0755 22.3214 +9718 4 8.87327 24.2546 5.53613 0.42871 5.14079 -20.2862 +9719 4 9.64462 25.4438 6.24707 -3.48643 -17.4971 -5.55606 +9720 6 52.5676 27.2719 21.6547 -2.39965 -30.061 -11.5856 +9721 4 52.5233 26.307 21.7841 0.332471 11.3908 13.792 +9722 4 52.7558 27.2791 20.7178 5.02488 16.4903 -8.77251 +9723 6 7.3066 16.9604 33.5537 -1.04195 2.49046 -7.43677 +9724 4 7.33543 17.7138 32.943 1.81348 -0.803559 0.920864 +9725 4 6.38938 16.6816 33.595 -7.62852 -0.129201 -7.36731 +9726 6 43.922 25.2186 7.97522 -0.776236 -10.551 19.3716 +9727 4 43.2647 24.8119 8.58447 10.2741 2.86697 -16.6436 +9728 4 43.4353 25.9147 7.53069 -5.46224 6.25576 -5.43654 +9729 6 2.0869 27.1165 13.6049 -6.62274 17.6596 -9.16822 +9730 4 2.19606 26.2295 13.9488 0.235583 -10.4047 3.43352 +9731 4 2.56841 27.1544 12.7597 2.10867 -4.70259 8.20201 +9732 6 37.3318 18.2771 2.1863 -11.4974 3.81579 3.71073 +9733 4 37.5653 17.6745 1.47223 -1.7687 -9.97531 1.83125 +9734 4 36.746 18.9091 1.7765 -5.93566 5.03593 -3.95155 +9735 6 24.9999 10.057 0.434977 -12.0635 -2.74649 0.799886 +9736 4 24.3308 10.4048 41.7106 3.78591 -9.33137 12.164 +9737 4 24.5954 9.37599 1.02184 5.69483 17.6459 -16.041 +ITEM: TIMESTEP +10 +ITEM: NUMBER OF ATOMS +9737 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 5.4990000000000002e+01 +0.0000000000000000e+00 4.1909999999999997e+01 +0.0000000000000000e+00 4.1909999999999997e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 9.97007 5.59928 0.0158605 6.82717 25.1566 0.173859 +2 2 9.62356 5.56404 40.5109 2.42388 15.8202 -17.9785 +3 2 8.17494 6.05177 40.4142 55.7411 37.9916 -4.02595 +4 3 7.24177 5.30408 40.552 -31.6102 -16.3698 1.50252 +5 4 9.18703 5.26911 0.576869 6.09491 -0.0281501 2.37507 +6 4 10.258 6.55078 0.333037 -13.6694 -25.1619 -9.93433 +7 4 10.7495 5.00053 0.227298 4.73684 -5.2578 1.97242 +8 4 10.3453 6.24708 39.9044 -16.4644 -11.4072 20.4818 +9 2 9.76873 4.13927 39.9675 -11.4588 -40.6165 34.779 +10 2 9.50273 3.78744 38.4932 15.666 28.6261 8.68394 +11 5 10.1133 2.12508 38.0108 0.295651 13.5297 3.11239 +12 2 9.21855 1.10832 39.2168 14.7368 7.58368 -1.20954 +13 4 9.08721 3.4839 40.6484 10.5431 15.7462 -21.5186 +14 4 10.7894 3.80905 40.2705 3.27862 -1.66199 -9.78219 +15 4 9.96352 4.6291 37.9056 6.4614 -19.967 -0.497951 +16 4 8.45197 3.92389 38.2658 -20.9649 -8.28542 -1.62155 +17 4 9.45855 1.42591 40.2577 0.123087 -4.74543 -3.47868 +18 4 9.48787 0.0601841 39.0477 5.23249 -11.9374 1.58081 +19 4 8.1518 1.18086 39.043 -21.148 5.31153 -2.14239 +20 1 8.09229 7.41048 40.3029 -14.2332 10.7223 -5.89196 +21 2 6.79937 8.10304 40.1889 5.24089 -19.8495 27.4218 +22 2 6.18195 7.49232 38.9365 0.114954 6.75236 -38.7125 +23 3 6.7427 7.67352 37.8124 -12.8129 -5.94191 21.2876 +24 4 8.91546 8.03754 40.1502 -4.33809 -15.705 2.93584 +25 4 6.18636 7.83053 41.1247 8.71228 4.86543 -21.2479 +26 2 7.05427 9.64124 40.1755 -39.1485 4.05492 14.7867 +27 2 5.78354 10.5475 40.1236 1.30256 17.7056 10.1762 +28 2 4.88546 10.5193 38.8862 -3.79578 -25.0164 33.8013 +29 3 5.09523 11.2746 37.9701 4.75276 20.2207 -26.2166 +30 1 3.8145 9.69296 38.9578 -10.6259 3.8922 -22.0733 +31 4 7.59986 9.93872 39.279 22.1314 0.316188 -7.87442 +32 4 7.59095 9.90263 41.1476 2.09094 2.02455 -19.3111 +33 4 6.10317 11.6308 40.2015 3.5236 -15.0099 -9.27626 +34 4 5.16114 10.4864 41.0336 -3.30627 -13.4665 3.57605 +35 4 3.54863 9.07856 39.7488 8.69916 3.95403 -0.745788 +36 4 3.18874 9.68238 38.1158 12.5738 1.24403 17.0425 +37 1 5.02604 6.79083 39.0278 7.4524 -0.797845 -45.9123 +38 2 4.17847 6.29332 37.9221 -3.7942 -15.2224 -3.95324 +39 2 2.69747 6.67222 38.2029 32.4064 16.6491 21.8024 +40 3 2.47317 7.27763 39.2627 -13.9875 -5.03172 -5.20453 +41 4 4.49693 6.75941 39.8611 -16.5463 3.77927 46.4214 +42 4 4.45927 6.7815 36.9606 1.68834 7.22657 1.16434 +43 2 4.32357 4.73766 37.6872 -14.444 16.6417 -7.09057 +44 2 3.62009 3.87951 38.7772 14.6644 -34.8859 1.43809 +45 2 5.79989 4.34797 37.5209 14.6689 -37.6664 -23.8861 +46 2 3.73665 2.34984 38.4383 -15.0607 27.3941 -9.62179 +47 4 3.8042 4.58537 36.6865 5.44811 -8.07725 9.84866 +48 4 2.54132 4.09064 38.8487 -7.82462 7.38089 1.0406 +49 4 4.05844 4.00808 39.8052 -1.99007 7.91776 -7.51683 +50 4 6.34139 4.39198 38.494 2.7915 9.59572 -3.8015 +51 4 6.26587 4.94741 36.6895 -0.816692 -0.0793993 15.4171 +52 4 5.96503 3.2496 37.1567 -11.5696 29.092 9.48874 +53 4 3.39623 2.18998 37.357 4.41378 -5.40883 18.8177 +54 4 3.12239 1.76276 39.1489 -5.35757 -4.6989 -2.16583 +55 4 4.76682 2.00075 38.5743 10.6291 -5.64517 -2.52342 +56 1 1.71265 6.3536 37.3575 -33.5913 -12.5481 -9.77554 +57 2 0.284755 6.62158 37.6816 12.6554 33.7668 -4.20076 +58 2 54.3822 5.43344 37.3699 -27.7691 3.87457 8.29319 +59 3 54.7838 4.49252 36.6867 3.01204 -3.04336 -3.37779 +60 4 1.82497 5.72672 36.5372 4.10411 3.68048 5.38879 +61 4 0.194803 6.88576 38.7694 2.48378 -12.979 2.09758 +62 2 54.7189 7.90551 36.9466 -7.72609 -12.13 5.61678 +63 2 0.656639 9.069 36.6919 -2.01357 8.03554 13.9604 +64 2 1.52683 9.2194 35.5966 7.55435 5.75852 -14.6577 +65 2 0.515029 10.1503 37.577 28.0972 23.5099 -14.6501 +66 2 2.25128 10.4257 35.3726 -4.96866 -39.5758 -10.6477 +67 2 1.27413 11.3326 37.3973 2.53894 16.486 1.64204 +68 2 2.1477 11.4375 36.2812 10.2448 65.1187 39.3263 +69 4 53.8018 8.25583 37.5371 13.1335 -2.90056 -11.9634 +70 4 54.3208 7.62968 35.9579 -2.73912 -6.0948 -8.85904 +71 4 1.62786 8.40831 34.848 -1.08621 1.70246 3.68663 +72 4 54.8519 10.113 38.4282 -15.3846 -1.92761 17.9785 +73 4 2.932 10.5406 34.5118 -0.192368 -3.19302 0.526177 +74 4 1.1987 12.2443 38.1226 0.692592 -32.2473 -20.0357 +75 4 2.79857 12.4271 36.2097 -23.9561 -41.0367 -3.09354 +76 1 53.0712 5.5328 37.7893 -5.57771 32.7805 23.2413 +77 2 51.973 4.62909 37.5111 5.69369 -27.8287 -42.174 +78 2 50.7933 5.44178 36.9635 6.83138 2.9595 14.8019 +79 3 50.2601 6.28483 37.7029 -2.00888 -3.43203 -15.9694 +80 4 52.7232 6.34215 38.4237 19.8206 -30.3225 -23.0649 +81 4 52.294 3.8899 36.6472 -5.7065 17.91 27.0613 +82 2 51.558 3.79481 38.7755 -4.51595 7.33433 1.21121 +83 2 50.3828 2.83682 38.5018 -9.13901 -44.4412 -29.5986 +84 2 52.8166 3.00155 39.2294 -15.7012 -7.04664 11.9409 +85 4 51.1774 4.47766 39.5861 12.1653 -0.853429 -2.8896 +86 4 50.5215 2.15128 37.5875 8.57056 17.9281 16.1392 +87 4 49.4053 3.30815 38.2892 0.50336 12.9055 3.57196 +88 4 50.1645 2.10956 39.3273 7.20165 10.7054 2.61524 +89 4 53.3305 3.56036 40.0335 2.85201 1.25263 3.90533 +90 4 53.556 2.88446 38.4204 4.77396 -6.45058 -3.13498 +91 4 52.5519 1.98529 39.6413 5.25091 8.27159 -2.68354 +92 1 50.4114 5.20625 35.6841 -20.1476 8.87025 -3.50293 +93 2 49.1688 5.73971 35.0966 -28.9774 8.99335 -1.66554 +94 2 48.0726 4.67952 35.3573 13.5632 -27.7837 -20.7653 +95 3 48.2724 3.51151 34.9309 -12.9152 20.0019 12.3092 +96 4 50.758 4.377 35.1895 1.67728 -2.63512 -1.50997 +97 4 48.8371 6.69602 35.5973 10.748 -7.18216 5.66994 +98 2 49.2038 6.04752 33.5367 10.0422 21.5226 29.5984 +99 2 47.9776 6.84135 32.9981 5.60977 17.6728 -19.5296 +100 2 48.06 7.31101 31.4919 41.3779 8.51018 8.58065 +101 2 48.2223 6.22581 30.3803 10.2277 10.7815 -8.37061 +102 1 48.1882 6.76889 29.0124 -44.0668 -20.3552 -6.98541 +103 4 49.2392 5.11894 32.9842 10.5057 -23.1259 -12.3022 +104 4 50.1653 6.62923 33.3927 -11.345 -5.02104 -10.4632 +105 4 47.825 7.77207 33.6051 2.48464 -5.23088 2.05035 +106 4 47.0343 6.2773 33.0942 -1.95432 -7.79908 6.21428 +107 4 48.9189 8.07819 31.4105 -13.7973 -19.6161 -0.159439 +108 4 47.1832 7.92091 31.2683 -17.7289 5.61577 -2.96622 +109 4 47.3306 5.536 30.4593 16.0468 -5.76301 1.4082 +110 4 49.2642 5.74618 30.4425 -24.8663 -4.45667 9.08666 +111 4 48.9827 7.28362 28.7526 29.3958 17.558 -6.10605 +112 4 47.3901 7.43056 28.8463 17.4375 -26.0151 1.0329 +113 4 48.1308 5.99149 28.2967 -4.23626 26.2635 18.8845 +114 1 46.923 5.03715 35.9679 -17.5656 23.7329 15.0201 +115 2 45.6707 4.26397 36.0383 7.41887 0.1342 36.2715 +116 2 44.9083 4.3955 34.7419 -9.99807 18.7078 -56.0122 +117 3 45.3082 5.1515 33.8118 -11.5681 -21.3087 27.1246 +118 4 46.8218 5.98238 36.4144 8.23522 -16.4135 -11.8728 +119 4 45.8989 3.17264 36.1884 2.80321 2.94058 -5.13324 +120 2 44.7401 4.70263 37.2808 -1.60464 -36.3649 -20.2774 +121 3 44.4616 6.07663 37.208 27.8602 32.4116 16.0792 +122 2 45.244 4.25605 38.6868 21.6281 49.2853 -20.5016 +123 4 43.7497 4.17807 37.1099 13.0537 7.54308 5.65065 +124 4 45.2592 6.57873 37.5303 -28.9412 -17.1189 -11.5145 +125 4 45.9129 5.11546 39.1089 -19.7485 -23.953 -1.10378 +126 4 45.8752 3.36487 38.6536 3.71139 -12.8851 -1.61893 +127 4 44.3595 4.03827 39.3021 -3.33201 1.23649 16.0156 +128 1 43.7613 3.66416 34.5997 13.2589 -16.0433 44.4251 +129 2 42.7828 3.62815 33.5465 18.9204 -1.21878 -42.6601 +130 2 41.7763 4.78741 33.7016 8.26701 -3.22526 52.4496 +131 3 41.2647 5.35582 32.7525 -2.05798 3.57411 -28.7638 +132 4 43.4932 3.04471 35.4154 4.99312 14.665 -20.8764 +133 4 43.36 3.79542 32.5266 -17.2288 -0.741434 30.8189 +134 2 42.0901 2.2209 33.4572 -3.06831 -30.079 -8.91003 +135 2 42.9343 0.899345 33.7586 6.86735 -2.69949 -8.81151 +136 2 42.2038 41.463 33.3849 1.50493 16.9918 14.9247 +137 2 44.2499 0.864187 32.9361 47.2855 12.5868 41.6398 +138 4 41.5678 2.05281 32.481 6.79941 12.0418 -2.16148 +139 4 41.2531 2.16469 34.1657 -6.29243 10.0771 8.19014 +140 4 43.198 0.869694 34.8519 -1.4112 0.953999 -4.44245 +141 4 42.8702 40.5903 33.6002 -4.10478 0.398246 -9.68788 +142 4 41.7896 41.4589 32.3582 7.27854 -3.68783 -7.38435 +143 4 41.3262 41.3063 34.0224 -6.75638 1.39507 6.42691 +144 4 44.0947 0.829251 31.8728 -5.75954 4.64229 -28.5029 +145 4 44.9396 41.8855 33.1737 -20.9549 12.1515 -1.19165 +146 4 44.9309 1.76601 33.2059 -22.5069 -20.3291 -10.4095 +147 1 41.5145 5.2236 34.9901 10.2672 4.08625 -51.0356 +148 2 40.6676 6.35891 35.268 -24.1778 -10.7223 -7.79527 +149 2 41.3691 7.72376 35.0974 2.95483 13.7574 -3.11119 +150 3 40.6975 8.75349 34.8431 -2.15612 -12.5202 3.44484 +151 4 41.8176 4.64617 35.7553 2.04542 -7.36824 24.1106 +152 4 39.8621 6.3427 34.4551 10.5786 9.41727 7.44594 +153 2 39.8405 6.1283 36.5756 19.8539 -2.67173 26.8296 +154 3 40.7601 5.89106 37.6735 -0.128972 20.3018 -14.678 +155 2 38.9248 4.89402 36.5497 -24.3083 -6.19306 -11.8519 +156 4 39.228 7.01129 36.8511 -0.372961 8.24506 -6.20484 +157 4 41.1549 6.75425 37.8536 -4.13097 -9.7211 -3.01543 +158 4 38.1722 4.94482 35.71 1.05658 9.14576 13.4136 +159 4 38.3953 4.71355 37.5213 -1.28546 9.2328 -6.30902 +160 4 39.3771 3.92967 36.3433 23.1336 -11.0543 -1.24287 +161 1 42.7302 7.8059 35.1562 3.49276 1.34371 4.78693 +162 2 43.5269 8.99303 34.9539 -8.19772 -21.7996 13.9087 +163 2 44.4646 9.39471 36.0778 41.0762 49.5413 -62.5687 +164 3 45.3993 10.2183 35.7654 -29.643 -36.0587 21.7786 +165 4 43.357 7.05719 35.4614 -7.13629 -15.5308 5.06399 +166 4 44.0803 8.92821 34.0189 14.2015 -9.60403 -10.8131 +167 4 42.9032 9.83742 34.7399 -16.6431 23.0824 1.78637 +168 1 44.28 8.95267 37.3076 -5.41717 -6.01048 56.4016 +169 2 45.1954 9.30059 38.3934 14.0544 9.09198 9.45122 +170 2 46.5736 8.71838 38.034 -4.40481 25.0392 4.24124 +171 3 46.7239 7.52665 37.7592 -2.06685 -10.8071 -7.31186 +172 4 43.4369 8.46722 37.66 -0.808029 1.80219 -13.797 +173 4 45.2932 10.4319 38.4595 -5.35026 -12.3633 -15.6489 +174 2 44.7775 8.83735 39.8303 19.1756 -23.9015 -7.23155 +175 2 45.4882 9.63492 40.9425 5.24315 -15.5914 27.8506 +176 2 45.0424 11.1143 41.0465 6.36216 -11.291 -10.339 +177 2 45.9827 11.9035 0.041605 38.3537 -2.96327 34.4916 +178 1 45.5586 13.2421 0.396463 -0.785075 15.3756 28.9492 +179 4 44.9912 7.72238 39.9953 -4.79728 17.8629 -7.78445 +180 4 43.7049 8.96345 39.9422 -22.2512 0.44531 4.07292 +181 4 46.5908 9.56019 40.8161 0.364544 3.82252 -6.52459 +182 4 45.3434 9.10335 0.0599805 -5.24686 13.9981 -23.7842 +183 4 44.0132 11.1324 41.4274 -10.2695 3.39123 6.70816 +184 4 44.9981 11.6023 40.04 1.8072 0.416607 6.15726 +185 4 47.0442 11.9436 41.5493 -17.6115 6.73335 -5.13538 +186 4 46.1824 11.4052 1.05233 -16.0491 -0.928483 -18.7699 +187 4 45.666 13.9003 41.5429 -6.15709 2.25656 -0.794581 +188 4 46.187 13.6261 1.17403 -31.6799 -14.737 -27.4943 +189 4 44.5482 13.2658 0.707841 33.0262 6.71149 -7.77427 +190 1 47.5786 9.61919 37.9975 -0.262725 18.6124 2.96873 +191 2 48.9681 9.33197 37.6414 -20.2336 1.72319 -17.1083 +192 2 49.7588 9.70622 38.88 39.5209 -76.7499 14.8721 +193 3 49.6145 10.763 39.4317 -9.44289 38.5374 13.5639 +194 4 47.4009 10.6083 38.3248 7.77058 -18.5649 -8.96176 +195 4 49.0172 8.23798 37.4216 9.46753 0.884559 0.506936 +196 2 49.3323 10.1282 36.3163 3.6714 0.82331 31.2642 +197 3 48.3563 9.85046 35.3281 -8.1318 -4.77519 -4.71381 +198 2 50.6865 9.72677 35.695 -19.0046 0.743943 -11.7808 +199 4 49.2557 11.2077 36.6021 8.67648 2.0602 -8.11811 +200 4 47.5419 10.2678 35.5977 -2.15846 0.170791 -0.678761 +201 4 50.8563 10.2671 34.7416 2.67544 8.24981 1.47477 +202 4 50.7066 8.66813 35.3754 2.1247 -7.47433 7.78713 +203 4 51.5309 9.954 36.3541 9.43429 -0.352141 7.40173 +204 1 50.5004 8.65755 39.48 -48.513 49.986 -45.0014 +205 2 51.0618 8.74392 40.7907 20.8089 -26.4742 28.5407 +206 2 52.5708 8.35776 40.7906 -32.7343 -31.0986 -30.3541 +207 3 52.9098 7.36002 40.1044 19.6712 31.5314 12.7437 +208 4 50.5882 7.8265 38.898 12.8881 -18.9119 10.2231 +209 4 50.9863 9.78895 41.141 -1.46865 8.60563 4.12328 +210 2 50.3037 7.79505 41.8358 -16.725 28.936 13.8764 +211 2 50.252 6.27959 41.4904 27.2589 15.6434 -4.64867 +212 2 48.8609 8.35011 0.225019 8.85004 14.588 -17.6069 +213 2 49.3953 5.42325 0.497373 -18.8945 7.05888 30.2377 +214 4 50.814 7.95159 0.918621 8.35305 -8.94958 -7.30269 +215 4 51.3186 5.93048 41.4774 -6.84536 -5.23847 5.64953 +216 4 49.9408 6.1608 40.4387 -8.33431 -3.05112 -5.55566 +217 4 48.166 7.96072 41.344 -1.46 7.63128 5.53427 +218 4 48.8165 9.51657 0.246026 0.467008 -30.2893 -0.065267 +219 4 48.5175 7.97406 1.21641 -4.07563 3.27994 -1.48455 +220 4 48.2983 5.58085 0.347667 5.50609 -0.627552 -5.84055 +221 4 49.5344 5.58322 1.60624 7.63779 5.91871 -13.4594 +222 4 49.5909 4.36583 0.361303 3.03099 -20.7712 -9.01704 +223 1 53.3669 9.15083 41.5136 39.5682 14.7354 5.79836 +224 2 54.8443 9.26777 41.6313 -32.7918 27.0996 3.53674 +225 2 0.372396 8.2907 0.722751 15.0567 -33.4937 20.6099 +226 3 54.8856 8.2259 1.87915 11.4238 -3.26125 -20.3466 +227 4 52.9167 9.73978 0.288924 -10.841 14.2188 11.5997 +228 4 0.25416 9.07559 40.636 9.98484 -5.7038 -17.1316 +229 2 0.351513 10.7152 0.19938 0.985642 14.1538 -10.6635 +230 3 54.4575 11.7797 41.7528 -11.3464 -18.6066 -9.73211 +231 2 1.66903 11.1049 41.4122 7.34382 -22.4378 -10.8926 +232 4 0.4803 10.8256 1.29559 2.15483 -15.9854 6.57991 +233 4 54.1789 12.1729 0.660397 -4.76608 7.18995 2.46446 +234 4 2.02372 12.0909 41.706 2.9877 17.6459 6.95349 +235 4 1.57896 11.139 40.2943 0.339955 -2.68366 6.65003 +236 4 2.50746 10.4017 41.6821 -7.50419 3.69742 -2.77337 +237 1 1.45709 7.55056 0.343709 0.783377 10.0466 -6.42735 +238 2 2.26763 6.65075 1.15078 -32.6055 -6.94536 -7.22798 +239 2 3.71498 6.9634 0.985171 49.9575 39.4499 -62.468 +240 3 4.16139 7.41516 41.7733 -24.7374 -20.1855 46.264 +241 4 1.86812 7.64334 41.3079 -3.10568 2.79536 2.39364 +242 4 2.02547 6.77359 2.21072 -7.15361 5.99983 10.1715 +243 2 1.97017 5.19949 0.677115 9.24237 23.8034 -8.70369 +244 2 0.525 4.76245 0.942436 -1.25511 -23.3688 27.6866 +245 2 0.292475 3.39123 0.300736 12.896 -21.1671 11.4366 +246 2 0.300138 4.59931 2.47443 -32.0383 1.7301 9.08136 +247 4 2.70003 4.54767 1.15632 6.2908 -16.3803 10.1517 +248 4 2.22696 5.13751 41.5068 -3.29253 -1.30987 -4.15087 +249 4 54.7656 5.47042 0.590489 -8.39992 14.3218 -15.0438 +250 4 54.2418 3.05018 0.328915 -13.2626 1.11831 3.00682 +251 4 0.884488 2.58096 0.823664 -4.50955 14.351 -5.98985 +252 4 0.593908 3.34298 41.1636 3.48003 3.40906 -16.1017 +253 4 0.952355 3.83641 2.92287 8.67303 -5.41594 2.10418 +254 4 54.195 4.2418 2.71744 29.7111 15.4634 -7.25797 +255 4 0.523461 5.5584 3.03176 -8.55492 -11.4476 -4.98522 +256 1 4.54724 6.69628 2.0028 -11.6083 -5.66543 -5.23244 +257 2 5.9708 6.78048 2.07185 29.6953 24.7002 11.5216 +258 2 6.62679 5.47067 2.57826 -56.9161 -25.5018 -48.7527 +259 3 7.55514 5.44421 3.3345 43.3901 -4.04961 27.9945 +260 4 4.11753 6.29088 2.82459 -1.31884 -6.15538 19.0144 +261 4 6.38329 6.99012 1.0501 -1.44469 -12.2628 1.79191 +262 2 6.4556 7.99651 2.97484 -29.1307 10.2847 -18.0571 +263 2 6.5028 9.34873 2.22705 -18.2939 24.7932 5.04877 +264 2 6.67525 10.5485 3.20576 -19.6949 -28.8822 -17.9407 +265 3 7.83409 10.9407 3.49149 14.4815 4.00472 5.8048 +266 3 5.6204 11.0576 3.67938 3.00737 1.04452 3.25275 +267 4 7.46376 7.72864 3.29072 15.5933 3.84479 14.8832 +268 4 5.82416 8.22265 3.87848 3.62309 -20.6245 -0.107855 +269 4 5.50278 9.55154 1.65377 27.7023 -9.35583 7.15892 +270 4 7.36204 9.37759 1.52673 -1.86837 -2.39822 -10.1271 +271 1 6.01547 4.32119 2.13096 24.825 18.8056 21.8908 +272 2 6.40109 2.94617 2.38906 -11.7575 -20.1643 -12.9237 +273 2 7.81521 2.61654 1.77783 -56.2322 2.45294 33.4207 +274 3 8.31478 3.35811 0.966233 17.239 19.087 -22.9985 +275 4 5.23593 4.40493 1.50032 -13.4301 6.78787 -12.4159 +276 4 6.42741 2.74871 3.48587 6.57798 6.02642 3.28221 +277 2 5.2086 2.00284 1.82478 32.9723 -19.5112 -16.552 +278 2 3.90497 2.10853 2.63909 4.11684 35.775 58.6384 +279 2 4.90372 2.28313 0.318971 -25.0993 -16.9694 6.10511 +280 4 5.56913 0.900136 1.85726 -4.66192 22.2662 6.6067 +281 4 4.03562 1.77943 3.74204 2.08752 -4.13501 -29.3045 +282 4 3.08076 1.58512 2.20328 -21.6762 -25.4002 -11.7361 +283 4 3.47043 3.14079 2.79739 15.5883 -5.24062 -11.8252 +284 4 4.40039 3.24668 0.146776 -5.79992 5.24774 -1.28692 +285 4 4.20501 1.47402 41.8336 8.41255 14.6516 3.66501 +286 4 5.77159 2.28177 41.569 16.6343 -1.64949 -4.80555 +287 1 8.4358 1.54559 2.27475 36.6082 -11.5601 -11.8896 +288 2 9.77403 1.09441 1.8307 -27.8835 12.6882 -14.7267 +289 2 9.60932 41.7912 0.904414 -8.95822 -4.80133 -2.77359 +290 3 8.60977 41.0717 1.04857 16.9017 -0.350054 -8.54673 +291 4 7.96937 0.851078 2.83344 -16.1443 -13.3321 15.6909 +292 4 10.1447 1.96102 1.23179 21.7718 -7.90657 2.9301 +293 2 10.6071 0.627222 3.03652 -0.441548 -3.06629 28.3632 +294 2 11.1182 1.69736 4.03374 -39.6019 -9.33118 23.345 +295 2 12.4276 2.26482 3.60541 40.3504 -3.80329 2.03759 +296 3 13.4833 1.65854 4.00477 -10.9735 16.3163 -6.96273 +297 3 12.4619 3.21875 2.76405 -4.75337 -1.04793 7.93588 +298 4 11.5429 0.117807 2.72279 -4.90068 -9.43781 -6.0473 +299 4 9.98495 41.7532 3.61242 16.0495 13.2539 -10.4034 +300 4 11.2741 1.17979 5.05068 -3.18835 9.28581 -16.8758 +301 4 10.3234 2.48031 4.23808 10.2695 -6.11036 -3.24845 +302 1 10.6563 41.4604 0.0588169 -6.20046 -15.666 -8.24155 +303 2 10.7096 40.1842 41.1911 4.64874 21.5238 9.65168 +304 2 10.6577 38.9638 0.161439 -6.67174 -46.3648 23.9629 +305 3 10.1435 37.8848 41.6696 11.1653 29.5239 15.2576 +306 4 9.85832 40.1011 40.5066 -14.3391 4.69386 -5.52668 +307 2 12.0141 40.2124 40.3653 4.26726 1.71904 -5.44169 +308 2 12.4668 41.6661 40.4777 -1.00635 15.6111 -33.0282 +309 2 11.8673 0.323303 41.767 -12.6506 -21.5702 -15.1443 +310 4 11.8545 39.873 39.2959 0.539662 6.91875 10.5587 +311 4 12.8304 39.5641 40.7546 -3.32338 -3.68521 7.20301 +312 4 12.0951 0.327352 39.5607 -0.26902 -6.73625 15.8499 +313 4 13.5766 41.7696 40.398 -3.05617 -0.547794 6.53436 +314 4 11.6542 1.3898 41.6565 2.06281 16.0871 1.21765 +315 4 12.5433 0.162045 0.691867 15.5992 2.8717 16.0141 +316 1 11.2193 39.0766 1.4086 -4.36655 24.7542 -22.059 +317 2 11.4309 38.0888 2.42328 2.01986 -2.25877 10.0578 +318 2 10.2357 37.7662 3.3374 -3.13249 5.62439 -12.9442 +319 3 10.4243 36.9709 4.25096 -6.41092 -9.96708 1.94465 +320 4 11.5904 40.0068 1.66465 -1.36758 -8.10945 4.45955 +321 4 11.6246 37.1209 1.91909 1.66244 -5.96089 -4.69733 +322 2 12.7089 38.4628 3.26447 -19.7243 1.96837 18.865 +323 3 12.593 39.7548 3.85012 -16.3579 -13.4437 -0.292868 +324 4 13.6002 38.4999 2.63657 13.9756 -7.10852 -11.694 +325 4 12.8962 37.7302 4.10036 -1.36843 4.44789 -10.4248 +326 4 11.9859 39.6657 4.60642 10.4094 13.6351 -5.41979 +327 1 9.02275 38.3618 3.12708 -24.8633 34.0603 -47.8229 +328 2 7.7797 38.1104 3.9237 -5.5143 -4.40103 -12.4219 +329 2 6.80948 37.1627 3.16843 27.134 16.5749 8.61656 +330 3 6.86683 37.0056 1.95165 6.52379 13.0808 -10.3152 +331 4 8.81363 38.9852 2.21874 13.7891 -35.0234 50.9651 +332 4 8.06628 37.5753 4.84119 7.22917 -10.5654 7.4735 +333 2 7.01568 39.4093 4.3407 2.69101 -11.9593 -14.7657 +334 2 7.81876 40.1019 5.42325 -6.79454 3.60365 -28.1432 +335 3 8.28496 41.241 5.20721 -2.75331 10.4655 -0.123769 +336 3 8.08719 39.4782 6.47272 0.652509 -5.2024 22.4807 +337 4 5.97814 39.1687 4.67547 5.82193 1.31451 7.85599 +338 4 6.83632 40.0167 3.42407 6.48365 7.00102 3.75656 +339 1 5.92582 36.4787 3.90047 -14.2639 -13.8348 21.4567 +340 2 4.95916 35.6178 3.24268 -4.4575 6.83929 8.3992 +341 2 3.83929 36.4769 2.71202 -44.4588 -49.3176 -48.5312 +342 3 3.60925 37.6169 3.05258 2.07424 26.7384 14.4764 +343 4 5.8145 36.534 4.942 7.63157 5.21975 -16.3776 +344 4 5.40617 35.1414 2.34351 4.65472 -4.22423 0.555341 +345 2 4.39718 34.509 4.16235 13.2774 -34.7614 9.16528 +346 3 3.98438 35.0519 5.39575 -10.4467 6.31908 32.28 +347 2 5.50619 33.4543 4.48033 -18.4692 -3.54598 29.0115 +348 4 3.53919 33.9402 3.74776 -4.47694 5.79242 -10.2957 +349 4 3.62452 34.3759 6.00064 11.5458 5.5573 -22.0279 +350 4 5.86065 32.9579 3.58801 8.19644 -6.15464 -22.9143 +351 4 5.08151 32.5761 5.12909 16.3877 29.7333 -11.6263 +352 4 6.39565 33.9521 4.95041 -3.85278 -8.84208 3.35803 +353 1 2.97294 35.7888 1.83357 24.6732 25.9217 25.2152 +354 2 1.71267 36.3687 1.37347 -5.03432 -5.896 10.5631 +355 2 0.744229 36.5497 2.58991 -5.24139 24.3125 -23.8477 +356 3 54.9871 37.5497 2.63122 18.6385 -17.0409 3.73872 +357 4 3.28773 34.8825 1.44268 -6.98273 2.93822 -0.272558 +358 4 1.87243 37.434 1.07109 4.86902 -3.5162 -5.74397 +359 2 1.111 35.5523 0.154125 -16.9781 -2.34719 28.1775 +360 2 1.71191 35.9998 40.7076 5.75717 0.931703 -28.4951 +361 2 54.5365 35.7134 0.116808 -8.16561 0.919103 1.38616 +362 2 3.27145 35.9095 40.6267 -43.0781 7.09941 -3.6072 +363 4 1.31237 34.4411 0.36052 2.96229 18.9121 -10.1464 +364 4 1.38444 37.0145 40.3207 4.07875 -5.77915 19.4423 +365 4 1.27316 35.3433 39.9124 8.37762 -5.40948 6.65521 +366 4 54.0772 35.0942 41.2103 3.74338 3.48587 4.89864 +367 4 54.2123 36.7722 41.8688 5.5832 -2.69651 -3.34762 +368 4 54.0157 35.4055 1.08169 10.5414 -0.491815 -14.4897 +369 4 3.61367 34.902 40.8802 7.83264 -12.2373 1.45006 +370 4 3.69229 36.6315 41.3343 12.2091 5.94613 6.19684 +371 4 3.59275 36.1798 39.604 6.95495 -3.49191 -4.00644 +372 1 0.74604 35.6172 3.54454 -3.3388 -35.9018 49.598 +373 2 0.0112331 35.6552 4.85892 21.257 7.22823 -39.6883 +374 2 0.198256 37.0471 5.48367 -2.86302 -31.8341 -17.2866 +375 3 54.1912 37.6952 5.75353 -1.48181 26.0574 3.92406 +376 4 1.16676 34.6739 3.4098 -0.571923 12.3969 -9.16993 +377 4 53.9399 35.5324 4.59955 -13.6683 1.62606 4.36563 +378 2 0.479844 34.4894 5.77304 -8.63544 -0.437888 22.4632 +379 2 54.7769 34.3327 7.14546 -8.87326 -9.27459 2.92058 +380 2 0.0146857 35.4787 8.12524 6.60033 -5.57439 2.5368 +381 3 54.0952 36.3427 8.3329 8.35004 -1.43527 5.86114 +382 3 1.11008 35.478 8.75909 4.47833 6.11486 1.03148 +383 4 1.57132 34.5563 5.98457 -0.698959 1.91632 -4.64924 +384 4 0.309529 33.5134 5.28188 2.4365 -3.54209 -11.468 +385 4 0.179249 33.4003 7.64738 0.479338 5.67065 -5.66203 +386 4 53.6776 34.105 7.04833 9.83525 6.91672 -4.06122 +387 1 1.48459 37.3964 5.63734 26.9411 18.0032 -4.38534 +388 2 2.00708 38.6625 6.18614 -17.3218 -26.0277 -29.9987 +389 2 1.56827 39.8885 5.33406 1.07082 -15.6319 68.2882 +390 3 1.08143 40.8395 5.94485 1.04665 3.34176 -10.6171 +391 4 2.21263 36.6994 5.39095 -3.57075 5.04293 0.958686 +392 4 1.48422 38.7142 7.17744 15.2971 12.5748 0.959573 +393 2 3.55969 38.5843 6.25222 7.32448 -15.8569 15.0135 +394 2 4.09689 39.7132 7.09894 -5.63198 1.92213 9.01267 +395 3 4.56636 40.7179 6.56654 0.030916 3.04529 -1.1693 +396 1 3.96361 39.556 8.43894 1.042 12.9555 16.4237 +397 4 4.05831 38.7157 5.24953 -10.2579 -5.90723 4.64011 +398 4 3.91694 37.5778 6.70114 -5.07122 23.1073 -10.2752 +399 4 3.40266 38.7698 8.86734 10.6722 14.2638 -7.23316 +400 4 4.31989 40.3411 9.06061 -10.7144 -22.9188 -14.0526 +401 1 1.60475 39.819 4.02334 -43.55 39.5967 -43.6917 +402 2 0.959151 40.8062 3.12947 9.93922 10.0651 20.657 +403 2 54.4776 41.0208 3.48285 -52.4492 -13.4217 15.5726 +404 3 53.9715 0.237442 3.65017 19.1527 -10.2385 2.60078 +405 4 2.04263 39.1125 3.49268 25.4866 -43.7222 -11.6271 +406 4 1.43469 41.7946 3.36052 -1.16639 -0.650149 -3.04645 +407 2 1.13376 40.5205 1.61049 -4.45578 -2.70165 -27.9407 +408 2 0.490261 41.6149 0.695896 4.53105 0.20202 29.6943 +409 2 2.64975 40.4484 1.23692 -3.92583 -1.39436 -18.6979 +410 4 0.60342 39.5705 1.32385 8.41785 -1.89228 7.96418 +411 4 54.3692 41.6195 0.82936 4.25856 9.6792 3.81375 +412 4 0.622371 41.4492 41.5424 7.52435 -6.48816 -19.7965 +413 4 0.973053 0.688907 0.936332 -12.1275 -4.49455 -2.44597 +414 4 2.86969 40.4983 0.122209 -12.9804 -12.5133 18.6513 +415 4 3.14027 39.5547 1.69882 2.20392 3.04031 -6.93039 +416 4 3.17994 41.3387 1.56797 8.55742 10.8937 16.8775 +417 1 53.6665 39.902 3.64569 3.02926 35.878 11.6697 +418 2 52.2466 39.9148 4.06102 19.2385 27.0707 -26.8098 +419 2 52.053 40.5369 5.44904 5.36155 -11.3244 -6.70427 +420 3 51.0493 41.2119 5.6977 3.00195 1.8183 -1.23959 +421 4 54.0359 38.9941 3.4462 12.1828 -26.316 -3.91411 +422 4 51.7731 40.6655 3.34079 -4.82064 -14.7659 11.8755 +423 2 51.582 38.5149 3.95778 -5.61462 -20.1546 -9.91009 +424 2 51.4355 37.9559 2.49174 21.0062 -12.2216 22.8132 +425 2 51.0144 36.4629 2.37849 -12.7289 -13.0945 -11.3158 +426 2 50.8009 35.9817 0.883468 22.3055 45.8074 13.5352 +427 1 50.1864 34.6873 0.684667 2.36531 28.1154 -10.556 +428 4 50.5344 38.5648 4.38466 13.3699 -2.49694 2.21203 +429 4 52.2198 37.7725 4.53757 -13.8611 9.51826 -2.20414 +430 4 52.4594 37.9738 2.01537 -10.7122 14.3169 -4.94324 +431 4 50.6781 38.6054 2.01085 7.27079 0.282464 -15.5314 +432 4 50.0599 36.3043 2.92579 -2.19776 -0.350037 2.41174 +433 4 51.7586 35.7685 2.83822 0.223715 4.6579 4.31096 +434 4 51.8274 35.9658 0.402852 -15.0801 -2.53131 0.358002 +435 4 50.2142 36.8299 0.38331 4.02889 -26.7998 -2.47013 +436 4 50.6312 33.9821 1.2741 -7.74727 -6.99272 -14.4028 +437 4 50.1255 34.5169 41.5875 17.6482 -15.4813 7.31014 +438 4 49.2229 34.7469 0.909632 -22.6621 -5.40937 19.0501 +439 1 53.014 40.2496 6.3528 -7.33511 22.7823 24.6419 +440 2 53.0995 40.7279 7.73814 -49.8191 -29.044 -3.24915 +441 2 53.1557 0.329785 7.7965 36.8238 12.814 -39.8954 +442 3 52.5287 0.997511 8.60414 -15.9304 4.02299 13.5617 +443 4 53.7341 39.5741 6.15629 12.7417 -17.108 -13.0125 +444 4 52.0658 40.401 8.2322 35.0205 13.5384 -7.46142 +445 2 54.2887 40.0362 8.44194 -31.1952 -6.28028 37.9979 +446 4 54.3393 40.3597 9.51814 11.9598 15.0179 -15.3163 +447 4 0.207826 40.1934 7.85611 17.4499 5.7482 6.56468 +448 4 54.1321 38.9464 8.61757 0.233079 -2.0185 -17.8759 +449 1 53.9798 0.938968 6.8679 -0.195991 -19.5991 -5.8991 +450 2 54.0539 2.3703 6.69095 -13.0728 33.3033 12.6105 +451 2 52.7411 3.03405 6.19669 -13.7918 -57.342 -43.9621 +452 3 52.3429 4.1409 6.51048 0.805927 21.8583 24.6591 +453 4 54.6966 0.402301 6.30051 -22.9471 7.504 14.9388 +454 4 54.1387 2.85352 7.70963 6.90446 -7.48262 -5.16091 +455 2 0.230181 2.82991 5.77971 -8.39605 37.5401 -18.7849 +456 2 1.62806 2.36187 6.13631 43.8101 -17.859 13.5365 +457 2 2.01439 2.63812 7.6434 4.44409 -15.8917 -34.667 +458 2 3.251 1.82053 8.03886 10.3698 -25.435 21.3536 +459 1 3.78609 2.13458 9.37971 -1.03569 -21.7613 -70.4054 +460 4 0.236987 4.00662 5.72725 -0.841737 -32.3075 1.88093 +461 4 55.0233 2.47547 4.72977 -1.92078 4.0191 4.58104 +462 4 2.43886 2.84427 5.52141 -13.7997 6.98566 -1.14785 +463 4 1.8001 1.26942 5.8525 -13.1218 12.7308 11.199 +464 4 1.17734 2.2629 8.25415 -4.76662 9.03037 15.6753 +465 4 2.26439 3.72233 7.77766 -11.2971 -1.006 3.39024 +466 4 4.0605 1.91272 7.29579 6.96563 5.43042 -1.59904 +467 4 3.03028 0.709673 8.06144 -4.99399 12.6268 -3.20223 +468 4 3.89697 1.2978 9.90866 2.2165 -13.9672 17.3419 +469 4 3.11983 2.70535 9.83652 -2.18207 25.7622 26.4666 +470 4 4.71792 2.51816 9.23842 -3.78155 13.4581 18.6473 +471 1 52.0021 2.30339 5.27929 12.8772 20.7449 44.6796 +472 2 50.6928 2.72834 4.84618 -13.8318 -0.832969 -24.58 +473 2 49.579 2.58092 5.91693 0.565718 25.7533 -2.22664 +474 3 48.7752 3.51298 6.10069 9.60089 -13.9081 0.0850852 +475 4 52.4111 1.47967 4.84803 3.54375 -13.752 -6.04623 +476 4 50.7183 3.81521 4.5849 2.62435 0.742467 8.46338 +477 2 50.3339 2.0499 3.47904 12.4361 -26.7668 8.24264 +478 2 51.3981 2.34325 2.36407 -25.9391 22.844 -14.5031 +479 2 48.9153 2.37958 2.98651 -2.89914 40.9383 9.35249 +480 2 51.1891 1.41918 1.15407 38.5806 -15.4927 -30.3188 +481 4 50.4158 0.92469 3.65006 -8.90797 13.02 4.48026 +482 4 52.4055 2.20648 2.74929 18.7984 -5.45377 5.09466 +483 4 51.3666 3.42411 2.00589 -1.76359 -13.5005 7.53435 +484 4 48.1353 2.36077 3.79579 2.75746 -16.6411 -10.078 +485 4 48.6799 1.76326 2.11438 -14.9792 -11.0957 -5.84075 +486 4 48.8325 3.45193 2.63807 7.50371 -11.7896 -0.401559 +487 4 52.1004 1.43799 0.414216 -21.3416 1.39174 26.2203 +488 4 50.3409 1.68288 0.503068 -10.2032 3.93981 2.99084 +489 4 51.0565 0.33979 1.46483 1.72575 11.8892 -3.22767 +490 1 49.5807 1.53255 6.75244 19.5889 -24.3514 7.76629 +491 2 48.7262 1.39688 7.92951 3.12598 20.2674 -1.73108 +492 2 48.8873 2.63773 8.86406 -22.8968 -16.6402 -5.42224 +493 3 47.8891 3.05472 9.45614 -0.472007 6.27789 -5.95623 +494 4 50.2352 0.731103 6.58688 -10.8709 15.7502 1.66713 +495 4 47.6402 1.39986 7.60999 11.2933 -0.131061 -1.07735 +496 2 49.0614 0.0990051 8.70607 -29.9824 -25.1823 -11.7347 +497 2 48.2869 41.7602 10.01 13.4599 -0.122667 29.7563 +498 2 46.7828 0.0292377 10.0132 -0.929007 -24.4408 -23.1824 +499 3 46.2118 0.52149 10.9702 -12.9016 15.2185 13.9881 +500 1 46.1401 41.3429 8.96595 27.5879 22.2376 34.4467 +501 4 50.107 0.108866 8.97457 27.7162 -1.73681 3.74735 +502 4 48.8999 41.0818 8.03917 5.36927 20.2302 10.0129 +503 4 48.7183 0.460982 10.852 -8.35522 8.57003 -12.646 +504 4 48.4869 40.755 10.454 -1.65554 -4.90235 -14.5783 +505 4 46.6392 40.8985 8.22302 16.4703 -11.2583 -22.7525 +506 4 45.1487 41.2958 8.97726 -40.9601 -1.33251 0.190018 +507 1 50.0995 3.17318 9.05078 3.95851 -0.0485648 -3.79593 +508 2 50.3325 4.25644 9.97415 17.5873 21.0859 -2.62556 +509 2 49.9752 5.63804 9.37548 -18.0954 -29.5198 29.938 +510 3 49.379 6.45094 10.0988 9.73071 -4.74536 -2.58342 +511 4 50.9107 2.76055 8.59957 11.9693 -5.38147 -4.75744 +512 4 49.6509 4.09994 10.8399 -6.9467 2.38538 1.23714 +513 2 51.7744 4.26209 10.561 -12.6039 -21.2869 -0.279481 +514 2 51.8614 5.17465 11.7883 77.4573 -1.34868 -55.222 +515 3 50.9415 5.19238 12.5756 -62.6641 4.37367 45.7089 +516 3 52.9385 5.83334 11.9521 -15.5069 -3.45829 -0.856418 +517 4 52.5513 4.49045 9.80335 -1.41111 7.91559 -3.33271 +518 4 51.9847 3.17606 10.8252 3.56611 15.7947 8.37571 +519 1 50.1134 5.83384 8.05697 5.03044 -3.38183 -24.9476 +520 2 49.6949 7.07302 7.45907 -6.39224 21.6045 -14.6025 +521 2 48.2404 7.19765 6.96855 9.41443 -40.5535 -11.5325 +522 3 47.5994 8.23003 7.09737 -2.60339 17.4007 5.13595 +523 4 50.5903 5.18529 7.39903 -4.72806 0.48988 13.3104 +524 4 49.6568 7.79446 8.28532 6.84483 14.8177 6.93296 +525 2 50.7045 7.63108 6.39006 -19.8247 -9.47824 8.02755 +526 2 50.6996 6.84785 5.08902 -10.629 2.31661 -15.1243 +527 2 51.6586 7.26626 3.9659 -11.3496 43.5825 3.95364 +528 2 53.1317 7.00105 4.2557 32.8208 18.7244 -18.8206 +529 1 53.7683 7.95578 5.14747 -10.6729 7.59108 -11.9454 +530 4 51.7028 7.64661 6.81348 16.7201 -1.45014 11.0251 +531 4 50.4708 8.68128 6.19684 -5.34256 14.1207 -5.41714 +532 4 49.6713 6.8702 4.6668 -0.861277 1.74329 -1.61352 +533 4 50.8688 5.79892 5.31654 5.28855 -19.0543 2.54637 +534 4 51.4741 8.35024 3.65396 8.42695 -12.5098 16.2485 +535 4 51.3565 6.79125 3.04708 -1.5826 -26.0582 -19.3792 +536 4 53.7673 7.0998 3.31183 -20.6632 -9.77681 9.39502 +537 4 53.2972 5.98514 4.64126 3.7215 -8.75629 2.11801 +538 4 53.3251 8.87081 5.17658 4.71004 0.103302 -2.74719 +539 4 54.7439 8.12131 4.95956 10.0262 2.1061 -7.58392 +540 4 53.7752 7.60869 6.06781 -3.05466 -8.65204 35.212 +541 1 47.7159 6.1092 6.3306 31.3529 14.3598 14.0351 +542 2 46.4076 6.11425 5.7591 -25.7668 -19.0326 -13.8071 +543 2 45.4013 5.23171 6.47844 56.1675 -11.9112 16.6864 +544 3 44.23 5.34684 6.24133 -49.2229 2.39302 -4.99484 +545 4 48.3398 5.28969 6.15889 -17.2258 10.451 -1.21207 +546 4 45.9358 7.11624 5.83656 4.3919 7.44058 4.79016 +547 2 46.401 5.6982 4.25555 12.45 -16.5042 -24.1702 +548 2 46.8608 6.82251 3.28226 -4.83626 -15.1342 -13.4955 +549 2 46.0803 8.13881 3.30599 -14.5444 -4.79224 -13.1752 +550 3 44.9716 8.27119 2.67975 10.7775 -8.64163 7.28309 +551 3 46.5691 9.08454 3.95876 4.86602 16.815 8.62941 +552 4 45.3845 5.39013 3.90204 -1.72737 6.76951 8.44594 +553 4 47.0179 4.72632 4.06618 -9.2699 26.8442 8.77601 +554 4 46.8747 6.40942 2.20799 2.04532 8.89503 18.2744 +555 4 47.9008 7.08537 3.56457 7.18737 -1.18981 -5.53646 +556 1 45.8799 4.29222 7.33829 -37.7514 2.20406 -4.61566 +557 2 44.9987 3.41141 8.06424 -3.99299 1.7641 -5.76947 +558 2 44.3276 2.33248 7.21969 -45.1266 -42.7281 27.6017 +559 3 43.411 1.613 7.73718 25.6836 24.6852 -13.962 +560 4 46.8488 4.10168 7.49502 31.0353 -1.43619 1.82022 +561 4 45.5349 2.87862 8.87403 3.80662 2.65181 2.49747 +562 4 44.2009 4.01738 8.56522 2.51171 -3.43938 -1.53795 +563 1 44.7359 2.05713 5.97006 1.92732 3.23614 21.462 +564 2 44.1948 0.978467 5.13766 -26.7101 17.135 -13.9432 +565 2 44.8486 41.5478 5.5025 3.41127 -20.6454 16.5554 +566 3 46.0871 41.4431 5.57675 -14.0525 11.0231 2.35631 +567 4 45.5581 2.59183 5.73006 15.6975 -3.64086 -27.3416 +568 4 43.0338 0.980574 5.28193 28.569 -9.56263 1.83686 +569 2 44.4255 1.37435 3.62453 6.02041 -5.1027 -4.41971 +570 2 43.5303 2.62118 3.29791 4.64703 16.7196 -23.7169 +571 2 44.2051 0.148173 2.67978 -29.1583 2.83252 11.5038 +572 2 43.5747 3.10962 1.83395 1.21002 2.08355 -6.515 +573 4 45.4937 1.66977 3.44724 -0.165314 0.952935 9.41179 +574 4 43.8006 3.52551 3.92139 -2.56937 -12.5949 1.07415 +575 4 42.4611 2.43664 3.46298 -10.2855 -9.14552 12.9963 +576 4 44.5119 0.377143 1.64896 8.27723 -0.881131 -7.54742 +577 4 43.1044 41.7625 2.59144 16.8524 3.81389 6.96191 +578 4 44.7846 41.171 3.05101 -3.46686 1.83863 -12.0461 +579 4 44.5392 3.56167 1.57116 9.55733 8.13116 4.62467 +580 4 42.7809 3.86627 1.57982 6.14378 -4.69974 7.81616 +581 4 43.4757 2.31615 1.08375 -8.22918 -11.6964 -1.57482 +582 1 44.0839 40.4233 5.76821 21.932 -1.5334 -8.86254 +583 2 44.7424 39.1674 6.24443 -3.28027 29.5462 -2.23354 +584 2 45.6232 38.4648 5.15467 16.5957 -3.17533 31.1682 +585 3 45.1655 38.1269 4.0769 -9.06079 2.14789 -9.97198 +586 4 45.3594 39.5074 7.13461 -7.15079 -15.4686 -7.49065 +587 2 43.5266 38.3049 6.70081 12.2837 2.36218 -7.01546 +588 2 42.3912 38.8204 5.83129 -5.25874 0.19697 14.2242 +589 2 42.6515 40.3318 5.90174 -25.8883 17.7161 37.6601 +590 4 43.2615 38.5482 7.76954 6.63706 -13.879 -3.94164 +591 4 43.7406 37.2122 6.50504 -6.24398 7.50926 12.4246 +592 4 41.3856 38.4747 6.1895 5.24712 7.09666 -1.13826 +593 4 42.5101 38.4102 4.83081 -0.0162975 -1.57753 -20.806 +594 4 42.2783 40.7857 6.94925 18.7272 -16.9878 -38.5107 +595 4 42.0764 40.8825 5.13323 2.00122 -0.967094 -8.03005 +596 1 46.8623 38.0021 5.57674 -15.3549 -23.0767 -9.82664 +597 2 47.7161 37.0187 4.84527 -3.88045 42.2808 23.2471 +598 2 47.0384 35.8723 4.15029 10.1677 -9.37304 -39.3599 +599 3 47.4551 35.4743 3.0324 -9.4669 19.846 29.5852 +600 4 48.2252 37.6386 4.0698 7.54977 -11.2433 -2.33648 +601 2 48.6452 36.5035 5.99482 -10.0312 13.1223 -5.95218 +602 2 48.8959 37.7819 6.80046 -4.41071 -5.72741 24.5975 +603 2 47.4918 38.4151 6.80561 23.284 1.3706 -4.72721 +604 4 49.5844 36.0861 5.59811 5.91725 -9.04521 -0.913385 +605 4 48.1158 35.748 6.64071 6.83063 -0.71303 -5.46675 +606 4 49.6383 38.4449 6.34864 7.02588 7.83512 -10.7506 +607 4 49.3019 37.5753 7.85532 -11.9914 1.76609 -18.7023 +608 4 47.544 39.5162 6.85821 3.72706 6.34433 1.60956 +609 4 46.9486 38.0654 7.68542 -11.5693 -5.06488 12.3189 +610 1 46.0019 35.318 4.78064 -26.4221 -3.88232 27.7903 +611 2 45.3025 34.13 4.26579 26.8092 19.3149 11.5505 +612 2 44.4585 34.46 3.02929 16.6723 1.23881 35.6677 +613 3 44.3932 33.6565 2.12406 -6.96945 -13.3218 -23.6344 +614 4 45.6895 35.6839 5.72645 6.17072 -11.3773 -21.4598 +615 4 46.1371 33.4525 3.9443 -9.57056 -4.48549 -9.01935 +616 2 44.5851 33.4333 5.41517 7.28023 -34.3989 -9.31284 +617 2 43.896 32.1478 4.95943 -2.5072 53.7563 23.2534 +618 3 42.6929 32.0377 5.28407 -11.6877 -17.8688 -5.68187 +619 3 44.6212 31.2997 4.42805 15.8429 -32.9345 -13.4225 +620 4 43.8908 34.1037 5.87793 -28.8167 18.0933 10.1447 +621 4 45.2673 33.1449 6.25678 1.67129 3.14432 -6.05002 +622 1 43.9425 35.6996 2.93756 -0.354949 -32.7532 -51.8723 +623 2 43.3733 36.2033 1.70184 -38.6892 -13.1006 14.7431 +624 2 44.3694 36.8017 0.73913 15.0439 4.82349 -39.1461 +625 3 44.0609 36.9601 41.4463 -0.757384 -5.0254 19.6545 +626 4 44.0082 36.3398 3.67638 4.88567 37.3717 42.7902 +627 4 42.8639 35.3314 1.17484 15.8753 7.76257 0.915116 +628 2 42.1931 37.1947 1.98861 35.687 20.598 -23.7763 +629 2 41.116 36.6037 2.88066 -6.28281 10.7168 27.7809 +630 2 39.8788 37.4748 2.97821 -20.6793 -12.2331 -39.8799 +631 3 39.5744 38.0012 4.02693 -4.5695 14.1805 28.3661 +632 1 39.0796 37.534 1.86047 23.989 -9.69865 9.57867 +633 4 41.7899 37.5369 1.00167 -6.59533 -6.76427 4.06671 +634 4 42.6371 38.1477 2.39011 -7.96796 -7.2267 7.32793 +635 4 41.4745 36.4913 3.95075 -0.75248 -0.913082 -13.6466 +636 4 40.7949 35.61 2.55083 -3.16107 -12.1939 -5.02302 +637 4 39.3636 37.1043 0.951835 -4.89499 3.13933 11.6446 +638 4 38.1602 37.9899 1.92801 1.07188 2.17452 -2.18356 +639 1 45.5977 37.1878 1.1702 -15.0402 3.91697 -26.2999 +640 2 46.6124 37.7593 0.269692 0.961344 -25.1749 -6.20454 +641 2 47.1251 36.6298 41.227 -15.6894 27.1972 18.7996 +642 3 47.6617 35.6605 41.7393 11.2436 -21.3221 -9.23089 +643 4 45.7953 37.0706 2.14421 15.4189 2.49224 25.3654 +644 4 46.1246 38.4981 41.5406 -7.74237 14.7139 -7.84953 +645 2 47.8075 38.4099 1.03092 10.1012 15.6193 -18.1996 +646 2 47.4246 39.6903 1.82563 -12.4684 -22.6418 23.6998 +647 2 48.6005 40.4099 2.51691 -17.3417 -7.9082 6.23218 +648 3 49.6876 40.5582 1.97833 4.99301 -0.872474 -9.60266 +649 1 48.339 40.8761 3.75079 34.2245 13.1834 24.2049 +650 4 48.6123 38.7237 0.293834 -9.9427 -4.45455 6.13719 +651 4 48.2879 37.6501 1.66455 2.7768 -3.8165 9.90104 +652 4 46.6323 39.34 2.60232 21.0344 18.1725 -15.5096 +653 4 46.9544 40.4315 1.1644 -6.65764 6.44375 -5.56957 +654 4 47.4103 40.9551 4.17425 -6.86232 -2.61251 -1.04516 +655 4 49.1568 41.2536 4.3255 -23.3959 -10.5461 -18.532 +656 1 47.0132 36.8194 39.8944 4.79393 -10.5252 -5.84263 +657 2 47.6604 36.043 38.8342 19.1375 -30.0942 8.85154 +658 2 48.4687 37.0132 37.9763 6.82075 18.1877 -22.3602 +659 3 47.9595 37.6039 37.0009 8.77071 -9.81154 18.2462 +660 4 46.405 37.5569 39.5258 -2.34297 5.9549 -2.23138 +661 4 48.4229 35.2731 39.2798 -19.3933 25.0679 -4.92238 +662 2 46.6775 35.1997 37.9517 0.490197 24.678 -10.7229 +663 2 46.0672 34.0096 38.7198 -38.9175 -0.700818 10.3629 +664 2 46.8744 32.685 38.9073 -3.26917 9.79703 -36.9848 +665 1 47.7628 32.6295 40.0786 -15.9706 28.2316 14.6984 +666 2 48.51 31.5331 40.3435 -4.63001 14.745 41.8738 +667 1 48.7312 30.5422 39.5064 -7.34995 -4.23697 -9.55446 +668 1 48.9018 31.3819 41.635 -19.9532 28.2508 -37.0556 +669 4 47.1729 34.8887 37.0027 6.80802 -10.5296 7.48075 +670 4 45.9076 35.9114 37.5121 1.10402 -9.8189 16.5264 +671 4 45.0997 33.7597 38.1755 17.1722 -3.36537 -3.11703 +672 4 45.6001 34.3514 39.6854 13.8349 -0.884929 -1.62484 +673 4 47.4022 32.4647 37.9216 2.87405 7.70981 18.3952 +674 4 46.1271 31.862 38.9206 0.553217 -4.0431 12.8995 +675 4 47.6279 33.4362 40.8042 9.43822 -37.2826 -24.9694 +676 4 48.3342 30.5657 38.5603 0.826291 -3.97588 -2.82687 +677 4 49.185 29.675 39.7859 6.04467 -9.07236 4.91997 +678 4 48.5432 32.0104 0.443983 -2.47374 7.53927 7.97734 +679 4 49.3442 30.5519 41.958 17.8055 -32.7958 11.0172 +680 1 49.7507 37.2761 38.36 -27.9891 3.94923 -10.3626 +681 2 50.6372 38.1716 37.6465 6.90802 9.01894 -16.7299 +682 2 51.1009 37.4739 36.3314 6.00851 -0.000986305 0.302592 +683 3 51.4496 36.2941 36.3505 -3.04594 -4.29189 2.8804 +684 4 50.1774 36.6397 39.0138 14.1864 -12.0724 14.4781 +685 4 50.0595 39.0583 37.2837 -1.51256 1.6517 8.14679 +686 2 51.8464 38.6091 38.5553 2.49074 0.426256 -22.3009 +687 2 51.5192 39.49 39.8069 -13.5557 -5.73698 -8.16935 +688 2 52.7888 39.6608 40.6664 -21 22.821 44.9745 +689 2 51.0354 40.8913 39.3667 -19.684 19.0705 -14.0846 +690 4 52.5817 39.1556 37.8894 -7.88883 -2.40182 8.97054 +691 4 52.3725 37.6699 38.8321 2.26719 1.04002 8.03718 +692 4 50.6848 39.0041 40.3963 9.50705 2.70236 -0.692257 +693 4 52.9505 38.8088 41.3668 0.716139 -3.31122 -6.89789 +694 4 52.7117 40.5855 41.3722 -1.5977 -23.2904 -18.3054 +695 4 53.6872 39.819 40.0903 21.6097 1.4026 -14.7648 +696 4 51.7777 41.4333 38.7338 5.73144 0.910017 10.7761 +697 4 50.6933 41.5309 40.2327 12.7628 -5.43827 -4.45399 +698 4 50.1361 40.9136 38.7005 3.06807 -14.6998 5.44273 +699 1 51.1637 38.2069 35.1833 -8.65277 46.2898 44.1617 +700 2 51.553 37.7419 33.8846 1.56046 15.8517 -26.9219 +701 2 52.7972 38.5563 33.3946 6.24297 -42.3048 -4.64985 +702 3 52.8896 39.7642 33.5814 -6.435 17.9384 2.35192 +703 4 50.9569 39.2647 35.262 8.21378 -41.2603 -12.3383 +704 4 51.8027 36.6701 33.8819 4.46523 -10.0245 6.73196 +705 2 50.2986 37.9511 32.9329 -9.17145 -5.64023 18.3882 +706 2 49.0629 37.0889 33.4059 8.5101 -2.50878 -15.0431 +707 2 50.6601 37.6697 31.4816 -9.00198 -6.28682 -34.5666 +708 2 49.2037 35.5513 33.2317 13.0867 -6.63955 11.9256 +709 4 49.9372 39.0006 33.0238 8.27291 6.69816 -3.39278 +710 4 48.1686 37.4323 32.8001 8.11156 -5.69031 9.58675 +711 4 48.8477 37.3684 34.464 -5.28515 -5.82898 -0.156702 +712 4 49.7508 37.5287 30.8047 12.011 -0.0430796 16.0089 +713 4 51.2928 36.7446 31.376 -4.11156 8.47591 0.32382 +714 4 51.1768 38.5507 31.0175 4.51478 -6.96789 5.36543 +715 4 50.1453 35.1216 33.7014 -11.0082 12.206 -5.4516 +716 4 49.2178 35.23 32.1578 -3.59036 3.22922 4.55632 +717 4 48.3665 35.0295 33.7638 0.68062 2.42879 -7.65558 +718 1 53.772 37.8505 32.7005 11.9802 38.3584 -9.99311 +719 2 54.8892 38.4918 31.9453 -18.9337 33.3604 36.4373 +720 2 0.0457823 37.9282 30.5422 -8.24024 2.92716 -24.5162 +721 3 0.594264 36.8423 30.3259 -11.3073 1.50903 5.31397 +722 4 53.7906 36.8495 32.616 -6.44893 -30.0966 2.1434 +723 4 54.5933 39.6185 31.9763 4.67753 -27.1194 -20.6963 +724 2 1.30394 38.4484 32.6241 4.82921 -5.73508 14.5601 +725 2 2.2605 39.423 31.9346 -38.1373 19.2777 23.8899 +726 2 1.83713 40.7771 31.9484 17.1926 2.24265 -1.86924 +727 2 3.4991 39.1266 31.4137 44.2785 -3.28979 -22.8275 +728 2 2.64242 41.8019 31.4282 -29.5168 1.86603 13.0701 +729 2 4.3212 40.1796 30.8558 3.27898 -39.2743 8.81887 +730 2 3.87185 41.4777 30.8782 6.24363 43.3598 -8.15054 +731 4 1.73925 37.4095 32.5315 -6.00214 7.91305 5.68876 +732 4 1.22265 38.7505 33.7444 5.52003 -9.57077 -28.715 +733 4 0.900292 41.0813 32.4345 -2.25415 1.01323 1.36593 +734 4 3.85804 38.0586 31.4239 -1.87041 17.6471 -1.97414 +735 4 2.21075 0.929728 31.5263 16.6224 -11.4708 -8.14622 +736 4 5.34427 40.0148 30.4252 -14.7168 -7.47964 5.81345 +737 4 4.49601 0.410438 30.4759 -4.95559 -13.7664 3.94973 +738 1 54.5157 38.6773 29.5249 -27.0888 35.6462 7.20647 +739 2 54.4663 38.361 28.1069 5.2815 -2.56059 -27.0064 +740 2 53.8105 37.007 27.8285 4.1142 -30.4598 -15.4676 +741 3 54.2925 36.1623 27.0158 -8.84 24.3654 24.6709 +742 4 54.0165 39.6075 29.7175 18.6271 -30.7219 2.56864 +743 4 53.83 39.1099 27.5328 0.819814 -7.88342 20.1611 +744 2 0.845681 38.4599 27.4009 -3.37868 13.1124 0.920574 +745 4 1.3644 39.4179 27.7359 0.635395 -16.0183 -8.53916 +746 4 0.720089 38.4757 26.2839 -0.330424 7.67272 7.0695 +747 4 1.43916 37.5478 27.5772 11.0328 -1.07232 10.5421 +748 1 52.6562 36.7643 28.4919 4.43857 42.1876 29.7882 +749 2 51.8688 35.5726 28.5678 11.3762 10.3615 -9.24037 +750 2 52.1836 34.677 29.7554 -56.6515 -45.7393 26.8579 +751 3 51.2796 33.8674 30.1477 33.9368 21.5747 -13.7315 +752 4 52.2409 37.5914 29.034 7.3769 -32.5773 -16.326 +753 4 50.8037 35.9045 28.6197 0.824464 -11.9292 4.40922 +754 4 51.9818 34.9789 27.6186 -1.74208 2.17118 9.08886 +755 1 53.386 34.609 30.3327 15.9463 0.295407 3.2668 +756 2 53.8702 33.5918 31.2906 -5.336 7.3854 -1.97925 +757 2 53.2724 33.784 32.6972 3.62039 -3.18208 -20.5224 +758 3 53.318 34.8834 33.2435 -3.37109 6.20646 2.08258 +759 4 54.0584 35.341 30.1321 12.3398 9.17802 -3.54281 +760 4 53.5469 32.5903 30.928 0.510164 -2.93777 -2.78072 +761 2 0.450375 33.6574 31.3834 -19.8167 20.6669 9.28695 +762 2 1.1189 33.1041 30.1021 -5.33927 -7.82927 4.13606 +763 2 2.62926 33.3565 30.0201 27.5042 -3.46073 -5.185 +764 2 3.52676 32.4236 30.898 -7.76336 10.6891 3.26174 +765 1 4.93921 32.7908 30.8651 -15.3408 -23.1293 6.29736 +766 4 0.715906 33.1135 32.3077 13.219 -7.49284 0.339296 +767 4 0.711888 34.7596 31.5921 3.25804 -21.2431 -6.20467 +768 4 0.610971 33.6189 29.2485 6.53106 -4.93764 -4.86032 +769 4 0.94328 31.9817 29.9891 -3.372 16.4508 0.497364 +770 4 2.92569 34.3879 30.2717 -10.3735 11.8265 3.32189 +771 4 2.96748 33.277 28.9434 -5.36763 -4.46501 9.75656 +772 4 3.3856 31.3899 30.5364 6.91643 -9.08032 2.48396 +773 4 3.23325 32.4634 31.9813 -4.58699 -1.94284 -9.93441 +774 4 5.35439 32.7181 29.9584 6.30767 5.94328 -10.9381 +775 4 5.52691 32.2429 31.4849 -0.455553 -3.36681 1.56927 +776 4 5.05493 33.7218 31.1915 7.72328 25.1707 0.250012 +777 1 52.7526 32.6794 33.2917 -1.1678 -10.0217 7.16811 +778 2 52.3607 32.6823 34.7156 1.10255 -1.80451 -46.4405 +779 2 53.6298 32.9771 35.466 24.3124 -3.86391 3.03884 +780 3 54.7252 32.4235 35.2212 -23.0397 10.722 4.71956 +781 4 52.6718 31.7771 32.7765 -0.499018 10.5241 3.64804 +782 4 51.648 33.5318 34.8013 -6.43996 -0.39665 8.9378 +783 2 51.7643 31.3153 35.1205 -14.6608 -0.598675 31.299 +784 2 50.4472 31.4454 35.9643 8.77941 -15.5352 -26.1807 +785 2 50.5832 31.9625 37.3651 -2.67912 16.3525 37.5763 +786 3 49.9209 32.9494 37.7433 9.07957 -2.58057 -6.15032 +787 1 51.437 31.3297 38.2211 2.67596 1.57171 0.930055 +788 4 52.5216 30.7277 35.7054 -4.20254 0.0350677 -4.46682 +789 4 51.4878 30.6783 34.2719 3.29993 -4.42069 -15.0162 +790 4 49.9434 30.4567 35.9623 3.78404 -4.63917 10.5702 +791 4 49.6858 32.0412 35.427 2.21977 11.0074 -1.38139 +792 4 51.8063 30.3924 37.9705 2.16328 6.00798 1.3625 +793 4 51.6437 31.7399 39.1747 -6.68696 -10.5036 -22.3596 +794 1 53.5095 33.8962 36.42 -8.20166 25.4414 22.1973 +795 2 54.5747 34.3024 37.3295 -19.3274 -47.2338 19.7644 +796 2 54.3374 33.5175 38.6424 -52.3016 59.5202 -10.0971 +797 3 53.3688 33.7998 39.3891 18.863 -9.21915 -6.06634 +798 4 52.6243 34.4292 36.5865 8.7567 -9.68897 -5.69769 +799 4 0.524888 33.8606 36.995 20.2449 10.0463 -17.6441 +800 2 54.6326 35.7977 37.4305 -12.9517 47.1344 28.5316 +801 2 0.0326923 36.4499 36.0829 -2.43572 -2.53932 -10.8482 +802 2 0.0400304 37.9734 36.2703 -35.7369 26.7596 -9.32276 +803 2 1.42323 35.9178 35.6511 7.48175 21.564 37.2538 +804 4 0.37702 36.205 38.1946 -7.23177 -18.0499 -4.52301 +805 4 53.6103 36.1739 37.8346 22.3749 -7.86488 -15.795 +806 4 54.308 36.1878 35.2646 -5.73883 1.17112 4.65385 +807 4 54.1487 38.389 36.8719 12.989 -15.5349 -14.8375 +808 4 55.0091 38.5546 35.2982 1.66458 -12.2972 11.8538 +809 4 0.898146 38.314 36.8215 26.4509 7.27198 12.604 +810 4 1.38795 34.9003 35.2548 1.76467 -17.1685 3.06812 +811 4 2.15782 36.0461 36.5409 -11.2535 -11.763 -23.0993 +812 4 1.84494 36.4876 34.8385 7.70144 16.3511 -18.9114 +813 1 0.00368541 32.3928 38.6933 60.3495 -72.1401 -12.2197 +814 2 54.849 31.2911 39.6724 -12.054 11.0917 -33.5573 +815 2 0.456178 31.7903 40.9874 10.6429 2.84259 -7.8967 +816 3 1.61925 32.1816 41.0469 -1.25889 2.69502 -0.320895 +817 4 0.771148 32.2113 37.9508 -27.5595 2.34137 31.2634 +818 4 53.7516 31.0568 39.7052 4.35339 2.80588 13.4321 +819 2 0.572301 30.0297 39.0906 18.5839 -9.3637 1.30639 +820 2 0.330271 28.7129 39.848 -4.85336 -14.889 23.6916 +821 2 0.693398 28.6486 41.365 -25.7394 -2.5332 -16.7842 +822 3 54.7394 28.745 0.295995 1.88939 6.38348 7.55667 +823 3 1.88537 28.4667 41.718 12.1129 0.623711 3.73015 +824 4 1.68124 30.2872 39.0755 -12.926 -11.288 -1.20667 +825 4 0.269733 29.7427 38.025 4.32739 20.9521 12.5377 +826 4 0.909417 27.8521 39.409 -5.73579 9.2082 -7.491 +827 4 54.2152 28.4395 39.7334 16.9231 1.48772 2.1114 +828 1 54.6305 31.7883 0.132952 22.8608 6.07746 39.2243 +829 2 54.8576 32.3299 1.48573 -29.3221 31.1311 -21.4901 +830 2 1.17253 32.0229 2.2009 17.6366 -16.111 10.5973 +831 3 1.59057 32.8071 3.07156 -0.674056 0.0659302 -13.788 +832 4 53.659 31.6017 41.9208 -28.5726 -8.3455 -12.917 +833 4 54.8441 33.4787 1.30532 5.06012 -29.8204 14.0187 +834 2 53.6539 32.0394 2.47663 -0.820586 10.1398 -23.6755 +835 2 52.2239 32.3686 2.01123 21.8921 -9.62397 -13.268 +836 3 51.4302 33.0165 2.73635 3.85378 3.64717 10.9914 +837 3 51.8951 32.0293 0.84168 -3.94391 -2.23918 -4.0609 +838 4 53.7898 32.6162 3.39279 8.30271 4.42614 18.4259 +839 4 53.7249 30.9715 2.71423 -6.48233 -12.4206 11.3701 +840 1 1.80027 30.8157 2.00429 -3.41308 17.021 -11.1273 +841 2 3.01391 30.3872 2.67306 -17.4243 6.23421 51.1709 +842 2 4.3573 30.5827 2.00701 -14.1548 15.4243 -63.5733 +843 3 5.42088 30.6338 2.61698 6.51202 -0.211014 15.7475 +844 4 1.38736 30.0831 1.41283 -0.948729 3.54349 -2.60962 +845 4 3.08525 30.9412 3.69277 -1.85342 -9.762 -26.0847 +846 4 2.85031 29.3254 2.98975 11.9317 8.24793 -5.27874 +847 1 4.28888 30.743 0.620497 -12.3621 7.32386 22.4338 +848 2 5.32937 31.2764 41.6512 -13.8663 -29.5394 -9.66616 +849 2 5.57121 32.722 0.10225 -38.3787 16.5244 28.1783 +850 3 4.67744 33.4061 0.685107 26.0808 -18.0695 -15.0621 +851 4 3.36015 30.6914 0.159011 7.3551 0.286523 4.85155 +852 4 6.25759 30.6643 41.7722 1.97617 9.44883 5.82281 +853 2 4.84937 31.1813 40.1487 29.2597 0.863212 8.06821 +854 2 4.69879 29.8019 39.4857 10.4894 -21.0831 -13.1113 +855 2 5.6473 28.6668 39.9936 -13.3021 -14.9024 -16.8737 +856 1 5.27077 28.179 41.3306 -2.96519 4.49812 -11.7353 +857 2 6.06985 28.0105 0.470368 18.4061 -2.74343 27.4639 +858 1 7.404 28.2193 0.415809 -33.9112 -6.97322 0.0250223 +859 1 5.53751 27.6715 1.66745 7.41355 -4.5447 5.6764 +860 4 5.59287 31.7875 39.5584 -6.62026 -5.01092 -0.797873 +861 4 3.90042 31.6963 40.0361 -18.37 16.2558 -2.13315 +862 4 4.87993 29.9347 38.3602 -5.0628 -2.10161 17.6043 +863 4 3.66163 29.4121 39.5629 -5.01534 4.60088 1.06729 +864 4 6.67981 29.0441 39.9161 8.56645 -0.645935 3.00783 +865 4 5.57604 27.7587 39.2774 2.4211 23.1794 17.5601 +866 4 4.26853 28.0084 41.463 -5.17362 0.488763 -0.181308 +867 4 7.82192 28.2777 41.397 19.0269 3.46358 -1.03101 +868 4 7.9555 28.2212 1.28205 9.21585 -1.90571 -0.36079 +869 4 4.50489 27.4888 1.75639 19.7441 2.64647 4.92685 +870 4 6.15841 27.5559 2.53009 -21.7479 0.642981 -21.0512 +871 1 6.76075 33.214 41.6912 19.219 -12.8447 -16.8584 +872 2 7.12868 34.5749 41.8436 1.78261 35.3429 43.0116 +873 2 6.77609 35.3298 40.5962 -19.1975 -45.9981 -46.2181 +874 3 6.48326 34.7082 39.534 6.6414 26.9902 28.4778 +875 4 7.37626 32.7254 41.0127 -5.73863 2.32833 8.30529 +876 4 6.55071 35.0559 0.812315 8.37617 -12.7412 -20.2377 +877 2 8.6392 34.7953 0.238234 19.5739 7.90851 -48.6006 +878 3 9.35353 34.1854 41.0304 -12.8386 -4.95727 8.3137 +879 2 9.11551 34.1669 1.50873 -18.8724 -23.6236 42.9663 +880 4 8.9088 35.8955 0.234805 -6.25165 -9.40588 3.92441 +881 4 10.2786 34.3917 40.988 -0.40493 9.85267 11.4657 +882 4 10.1184 34.4515 1.79035 25.1513 6.04912 0.147779 +883 4 9.07131 33.0605 1.52977 2.37755 -2.72972 -9.56943 +884 4 8.50911 34.4369 2.41136 -0.948376 7.25744 -9.18832 +885 1 6.94474 36.6394 40.6556 -2.44135 26.6434 -23.8261 +886 2 6.9184 37.5467 39.5347 6.69905 -14.1713 -12.8446 +887 2 8.05389 37.1964 38.5245 -27.4859 18.9986 34.7956 +888 3 7.86013 37.2053 37.325 -9.29767 -2.30205 -27.2404 +889 4 7.0965 37.1097 41.5252 4.96112 6.67936 34.6112 +890 4 5.99819 37.3272 38.9586 -4.63141 4.06603 -3.57729 +891 2 6.96111 39.0217 40.0249 7.60343 4.99798 32.9439 +892 2 5.64771 39.5459 40.7503 13.3303 -11.7686 1.87571 +893 2 5.75985 41.0532 41.0609 20.2812 5.99168 -41.4278 +894 2 4.32816 39.2726 39.9704 18.565 3.35099 -29.4893 +895 4 7.21258 39.6788 39.2071 1.58444 12.8598 -26.2647 +896 4 7.87294 39.1662 40.7418 -24.807 -6.41168 -15.2883 +897 4 5.6203 39.0148 41.7319 -7.34537 -3.15131 1.25362 +898 4 4.91646 41.4032 41.6252 -26.0876 7.76092 9.54018 +899 4 5.84653 41.6805 40.0749 -1.44823 -14.0856 28.5036 +900 4 6.60816 41.2866 41.7276 9.52725 -0.69638 -3.08419 +901 4 4.29893 39.8385 38.99 0.215491 -3.12837 12.3269 +902 4 3.42741 39.5069 40.5265 -12.1672 8.54215 8.82184 +903 4 4.17367 38.2217 39.6869 7.24572 -5.84244 0.858739 +904 1 9.22626 36.8637 39.0427 21.4973 3.37181 48.1033 +905 2 10.3674 36.5714 38.2232 -9.10154 -9.23991 0.387697 +906 2 10.2983 35.2598 37.4643 -7.87493 -21.516 -1.82692 +907 3 11.0121 35.0941 36.4546 -10.096 5.18496 3.08952 +908 4 9.43559 37.0753 40.0799 -6.60045 -9.32212 -38.2223 +909 4 10.38 37.3229 37.4195 5.65865 10.6121 -8.5187 +910 2 11.637 36.6734 39.0312 17.5501 -7.37692 6.57672 +911 3 11.6795 35.7227 40.1079 -2.8679 20.1807 -0.19791 +912 4 11.748 37.6704 39.4409 -4.03165 17.0402 13.6797 +913 4 12.5247 36.6276 38.381 6.78129 -14.3562 -2.26856 +914 4 12.1944 34.9922 39.8075 10.5839 -13.8343 -8.97123 +915 1 9.37599 34.317 37.8723 17.0981 22.6825 36.4547 +916 2 9.03961 33.1663 37.0884 -21.5177 -32.5135 -8.8238 +917 2 8.42186 33.6216 35.772 12.1136 -61.8885 -37.6156 +918 3 8.46238 32.81 34.7849 1.32901 29.1307 35.9822 +919 4 8.95542 34.3811 38.853 10.4706 -4.46378 -29.0763 +920 4 9.93142 32.5518 36.7616 2.79547 16.9463 9.21372 +921 2 8.03197 32.1466 37.7484 3.42637 10.6841 -18.9321 +922 2 8.64707 31.2467 38.7916 -6.9544 1.67927 -4.64681 +923 3 8.29676 31.4213 39.9815 6.74685 -6.11142 9.13282 +924 3 9.44706 30.3423 38.4151 3.7337 3.36295 -6.87259 +925 4 7.50152 31.5448 36.9637 8.39997 -2.11551 6.41653 +926 4 7.19405 32.7023 38.1775 -8.25993 10.1263 10.5291 +927 1 7.75009 34.762 35.719 -22.4701 19.7147 -23.1057 +928 2 7.04455 35.3131 34.5484 -10.1936 -29.3849 23.8741 +929 2 7.86233 36.3488 33.8376 -13.0656 11.1044 -41.9487 +930 3 7.58485 36.6599 32.6528 -2.0293 -9.17756 21.4272 +931 4 7.63327 35.3235 36.5488 -2.91413 9.03335 17.0933 +932 4 6.86396 34.4501 33.8456 12.5342 10.3996 -5.08052 +933 2 5.61426 35.844 34.9306 19.6262 -1.52617 -28.8748 +934 2 4.83213 34.6653 35.4025 -10.2806 -24.7237 17.6593 +935 2 4.57558 34.457 36.7787 11.017 23.715 -9.65022 +936 2 4.42364 33.669 34.4835 -0.204454 17.9401 5.69744 +937 2 3.80293 33.3928 37.1817 -18.0339 -16.5573 23.9014 +938 2 3.6203 32.6104 34.8697 -1.59657 -1.57291 16.7967 +939 2 3.28719 32.4878 36.2185 14.3191 25.239 16.785 +940 3 2.42643 31.5967 36.7004 -21.786 -29.0921 6.36516 +941 4 5.08947 36.2348 33.9913 8.47084 3.13833 18.0937 +942 4 5.68856 36.6154 35.7126 -3.45102 11.3715 1.65586 +943 4 4.93536 35.177 37.5545 -2.85956 -5.82375 -8.46254 +944 4 4.68581 33.7849 33.4351 -1.13786 -0.0334624 -10.731 +945 4 3.5508 33.3312 38.3093 3.7661 -3.16504 -32.8067 +946 4 3.21561 31.8879 34.1609 -1.14089 -4.88721 -7.16666 +947 4 2.07822 31.0058 36.0335 4.80509 5.07869 -1.12919 +948 1 8.89276 36.9109 34.4697 3.08208 2.61779 2.42454 +949 2 9.71554 37.9518 33.9536 6.78836 41.9101 -7.41895 +950 2 8.87118 39.1918 33.5791 -2.83098 -3.29658 16.5328 +951 3 9.07345 39.7706 32.5156 6.00915 0.294316 2.75033 +952 4 9.0886 36.6939 35.4314 3.3626 -5.13227 22.9354 +953 4 10.4005 38.393 34.7625 -11.752 -18.5108 -5.62727 +954 2 10.5665 37.5273 32.7526 17.9231 -22.0125 -23.4044 +955 2 11.7038 38.502 32.4536 -20.96 9.74481 -37.2535 +956 3 11.6878 39.1949 31.3977 0.540028 -8.54016 25.273 +957 1 12.687 38.5377 33.3475 38.0496 20.2334 23.5086 +958 4 9.97947 37.4403 31.7814 1.01798 2.165 18.3599 +959 4 11.0193 36.505 32.8955 -2.74071 8.1052 0.988861 +960 4 12.6531 37.864 34.1655 7.32082 17.5294 -13.3715 +961 4 13.4532 39.3055 33.2787 -30.6572 -33.7139 4.421 +962 1 7.93658 39.5767 34.4996 32.6534 -23.6413 -9.43678 +963 2 7.20273 40.8089 34.5743 -2.74612 21.1773 -15.346 +964 2 8.21766 41.8982 34.9197 -3.45605 -13.7782 10.2915 +965 3 8.98784 41.7778 35.8832 -3.40272 -3.46005 -6.10842 +966 4 7.93188 38.9898 35.3424 -7.46187 6.56739 7.86278 +967 4 6.79415 41.087 33.5295 1.97546 -9.26453 20.6229 +968 2 6.06472 40.6271 35.6481 -5.08297 -2.08213 -22.9213 +969 2 4.90833 39.9858 34.8157 -12.6977 -10.7104 -3.72739 +970 2 5.64222 41.9226 36.403 -2.05312 -2.0705 -19.9517 +971 2 3.84054 39.2603 35.6406 -0.0147652 -3.33058 30.6695 +972 4 6.3943 39.8459 36.3734 2.85979 7.06395 10.3389 +973 4 5.33061 39.1839 34.1245 -4.62997 12.2623 4.99778 +974 4 4.37584 40.73 34.1591 8.26763 -2.20969 2.2716 +975 4 4.92993 41.6478 37.2106 -0.0042749 6.0371 4.19307 +976 4 5.15795 0.778755 35.7389 -1.27911 -10.984 2.34352 +977 4 6.51935 0.549814 36.8166 0.412823 -4.00159 10.9885 +978 4 3.21428 39.9846 36.2492 8.55414 -9.22464 -7.99451 +979 4 4.28582 38.4972 36.3757 -6.36125 15.4526 -14.7269 +980 4 3.14756 38.696 34.9847 -1.95473 -0.292674 -1.44435 +981 1 8.25206 1.08297 34.1638 31.3741 38.5442 9.59718 +982 2 9.18814 2.19093 34.4552 -11.7272 -14.356 -0.722089 +983 2 8.45749 3.48131 34.8023 4.76941 7.21795 3.77261 +984 3 7.24176 3.59586 34.6101 4.23254 1.41941 3.46139 +985 4 7.75397 1.25241 33.3001 -16.6469 -12.6897 -14.3012 +986 4 9.75614 1.90919 35.3591 7.11639 4.99627 7.91164 +987 2 10.1452 2.40125 33.2642 -9.36205 3.53781 1.41258 +988 2 11.145 1.26701 33.0621 15.3724 -18.5317 -10.2549 +989 2 12.3408 1.2215 34.0193 -34.6799 -20.8737 -4.25674 +990 3 13.4283 1.6066 33.6334 28.2263 9.73281 -4.88467 +991 1 12.1185 0.540183 35.1633 28.8031 2.35628 29.4382 +992 4 10.7148 3.34616 33.3936 1.59432 0.534457 -2.79864 +993 4 9.49714 2.55965 32.3759 6.01649 -0.268224 -5.10448 +994 4 11.6127 1.34439 32.0577 -0.769775 9.57011 -1.56393 +995 4 10.6933 0.251936 32.9886 -5.52334 3.35231 7.85959 +996 4 11.2139 0.219277 35.5156 -12.526 -0.0546681 -6.86711 +997 4 12.9016 0.455342 35.8573 -9.00019 3.15098 -17.6728 +998 1 9.24699 4.48326 35.2867 7.50516 -22.9453 -9.87373 +999 2 8.79457 5.81029 35.6553 19.4094 -0.44208 23.4194 +1000 2 7.94193 6.35186 34.5098 -28.0836 13.7832 22.6841 +1001 3 8.26577 6.15625 33.3485 3.32417 -1.59684 -17.5239 +1002 4 10.2626 4.25405 35.3107 -8.01304 16.2193 5.9612 +1003 4 8.1894 5.68577 36.5846 -11.6257 -0.00282829 -7.04897 +1004 2 9.97767 6.74716 36.1433 -23.7266 14.1696 -20.2452 +1005 2 11.1395 6.93836 35.1562 2.17384 -4.68321 -25.171 +1006 2 12.442 7.40754 35.8023 6.89417 23.6707 25.6501 +1007 2 12.3585 8.87197 36.3546 -17.7601 7.18701 6.16378 +1008 1 13.652 9.40345 36.7619 -5.05233 -10.0697 25.3038 +1009 4 10.4674 6.41708 37.0624 -6.17454 -12.8958 16.6295 +1010 4 9.46609 7.72624 36.4439 19.6997 -12.4825 -9.52898 +1011 4 10.8586 7.67723 34.3661 -2.31205 -2.27426 2.47252 +1012 4 11.3956 5.98923 34.5935 -8.15618 9.36142 7.97067 +1013 4 13.285 7.3766 35.0989 4.02069 -2.74272 -14.2107 +1014 4 12.7725 6.74228 36.6382 -4.94702 -0.810609 -4.3443 +1015 4 11.6162 8.97546 37.2517 21.5709 -5.37851 -23.6156 +1016 4 11.9848 9.59279 35.5592 1.32622 -13.234 7.43529 +1017 4 13.5097 10.3531 37.0548 1.1249 12.5728 4.15723 +1018 4 14.3076 9.4933 35.9914 2.38442 -5.54985 1.16984 +1019 4 14.0989 8.9471 37.5942 -8.28554 10.0467 -28.7492 +1020 1 6.74258 6.95961 34.8453 13.8439 -7.08515 -31.5666 +1021 2 5.70412 7.47847 33.9372 22.4359 17.1833 28.8896 +1022 2 4.73468 6.47268 33.3926 -37.2702 -51.3286 -21.7325 +1023 3 3.66084 6.82477 32.8505 20.0183 9.28716 8.38675 +1024 4 6.50761 7.12516 35.8163 -0.959582 1.3178 20.8718 +1025 4 5.07512 8.17388 34.5809 1.06569 -12.1955 -8.24357 +1026 2 6.27511 8.35576 32.8097 23.4106 2.51452 -13.5767 +1027 2 6.97942 9.67377 33.2004 -16.9954 14.0421 10.4255 +1028 2 6.10535 10.8129 33.826 12.866 -26.3315 -27.4761 +1029 3 5.32563 11.4369 33.048 -2.57309 4.89094 -0.177716 +1030 3 6.28787 11.1355 35.0235 5.56298 3.82152 16.5631 +1031 4 5.49496 8.55729 32.0786 -16.2509 9.70978 -5.42728 +1032 4 7.00993 7.79082 32.1666 -6.62982 -1.98309 13.432 +1033 4 7.44051 10.1227 32.2823 5.63402 -3.39012 2.91122 +1034 4 7.79617 9.4262 33.9151 4.88029 0.56984 -5.69246 +1035 1 4.9985 5.11713 33.407 24.659 21.8647 21.6253 +1036 2 4.05493 4.11234 32.9569 -19.5991 11.2557 -30.6753 +1037 2 2.66349 4.36425 33.564 5.77052 11.5327 33.941 +1038 3 2.61183 4.63212 34.7889 -10.6254 -2.1096 -24.9185 +1039 4 5.90798 4.72579 33.7623 -18.8375 16.0079 -6.75199 +1040 4 3.94963 4.2178 31.8123 4.18537 -9.18741 21.4869 +1041 2 4.52113 2.73738 33.4375 8.25229 -17.2331 29.0433 +1042 3 5.75234 2.38881 32.7881 -21.5054 -2.62865 -12.7372 +1043 4 3.76903 1.95227 33.2696 -3.85539 -5.9091 -13.5606 +1044 4 4.62925 2.69715 34.589 6.20333 6.93314 -25.3828 +1045 4 6.43526 2.61043 33.3995 7.46021 4.72267 11.925 +1046 1 1.55191 4.21884 32.8032 -14.0425 -5.15851 -21.6842 +1047 2 0.161375 4.25438 33.2368 -9.40026 13.4655 23.096 +1048 2 54.692 2.80115 33.3646 18.1492 -1.83923 -37.1888 +1049 3 54.7885 2.04564 32.3679 -9.76904 2.34815 11.9713 +1050 4 1.58614 3.87283 31.8209 11.2241 6.42129 12.946 +1051 4 0.0932821 4.78062 34.2407 6.57702 -9.00044 -6.29593 +1052 2 54.1421 5.03026 32.3092 -30.8516 -27.3257 32.8914 +1053 3 54.4529 6.38645 32.3432 43.6526 11.7784 12.1317 +1054 2 52.6693 5.00292 32.8811 18.0931 2.75777 -15.9968 +1055 4 54.1554 4.62002 31.3044 4.18983 -2.87474 -22.2473 +1056 4 53.8639 6.90955 31.8518 -25.2917 13.9269 -18.693 +1057 4 52.66 5.46781 33.8932 -7.48107 5.39969 -2.18241 +1058 4 52.249 3.98991 33.0062 0.231344 -5.48034 -3.27193 +1059 4 51.9963 5.5356 32.1423 1.66512 -1.40627 14.088 +1060 1 54.1705 2.41097 34.5199 1.80418 26.5965 31.5441 +1061 2 53.4771 1.1604 34.7223 -23.5881 -17.4143 30.2256 +1062 2 51.9672 1.43692 34.4286 45.4706 11.6959 19.6168 +1063 3 51.5098 2.51334 34.8139 -14.0548 -1.70012 -4.22959 +1064 4 54.1449 3.13072 35.3168 -2.84084 -28.6208 -21.3152 +1065 4 53.8073 0.317305 34.0552 7.54144 10.0832 -0.542806 +1066 2 53.6466 0.727247 36.2732 15.0023 -0.977243 -19.0787 +1067 2 0.11045 0.778115 36.8855 -3.47233 23.3808 -12.4462 +1068 2 0.174657 0.0352411 38.2454 9.71436 -6.65086 -1.81426 +1069 2 1.19132 0.222888 35.8995 6.11034 15.7938 3.95568 +1070 4 53.2393 41.6189 36.352 -4.11551 -11.0062 3.39296 +1071 4 53.0266 1.35722 36.9407 -10.5209 2.31976 -3.99924 +1072 4 0.276909 1.89779 37.0745 11.3679 -17.77 -1.06189 +1073 4 54.361 0.442618 38.9125 4.10216 -8.97134 2.26246 +1074 4 1.16474 0.174268 38.7716 -10.2453 4.64912 -5.91146 +1075 4 0.0894693 40.827 38.1128 -8.07449 10.5575 2.47406 +1076 4 2.18017 0.0911741 36.3628 0.498668 -8.86502 15.8712 +1077 4 1.51082 0.946112 35.1046 -21.6742 -5.82018 -4.77892 +1078 4 0.87048 41.1455 35.5035 3.84873 -0.316194 -7.96637 +1079 1 51.2572 0.510776 33.7869 -35.0849 -22.21 -18.422 +1080 2 49.7991 0.651464 33.5457 -7.89552 -1.42073 2.85742 +1081 2 49.1064 41.7127 34.6422 20.8091 24.7993 -30.4476 +1082 3 49.3211 40.5176 34.6928 0.936017 -16.9834 6.81615 +1083 4 51.5685 41.4333 33.6514 6.90564 11.6478 3.53197 +1084 4 49.4699 1.73569 33.6536 7.71362 -9.58165 1.5915 +1085 2 49.2914 0.124722 32.1435 -1.6477 0.542595 21.3952 +1086 2 49.5957 1.07684 31.016 -40.6033 -15.585 26.437 +1087 1 48.7294 1.99918 30.4836 -27.6566 13.4748 -4.54446 +1088 2 50.7297 1.21695 30.3262 36.7247 10.1326 -33.1818 +1089 2 49.2902 2.59089 29.4013 15.6758 12.8861 -16.3634 +1090 1 50.5605 2.13547 29.3267 -27.6128 -3.77706 23.4645 +1091 4 48.1729 41.8384 32.2733 14.3125 6.04861 -12.1255 +1092 4 49.7214 41.0254 31.9181 -0.443629 4.48635 2.11286 +1093 4 47.7408 2.2006 30.8029 20.1006 -6.4749 -2.25561 +1094 4 51.6449 0.698065 30.4056 15.084 -12.5894 5.57169 +1095 4 48.9104 3.2954 28.6425 -5.47018 -10.6135 19.6435 +1096 4 51.2563 2.40703 28.6421 12.9903 7.46191 -13.5301 +1097 1 48.3611 0.457254 35.523 -13.4783 35.8963 4.98689 +1098 2 47.6684 41.7265 36.6028 -12.609 2.82517 16.7739 +1099 2 46.2613 41.336 36.1362 14.2498 9.86212 -6.63619 +1100 3 45.3696 0.249228 35.9008 11.2544 -8.11188 8.40093 +1101 4 48.1527 1.47601 35.3837 2.04907 -15.0615 5.33592 +1102 4 48.2568 40.8085 36.8471 -2.89667 -2.02658 5.80089 +1103 2 47.5596 0.692305 37.8969 5.07609 12.8861 -15.4572 +1104 2 46.7247 0.067171 39.0652 -23.3887 -7.36646 -24.3057 +1105 2 47.033 40.4837 39.4166 -14.2982 16.8046 -18.6717 +1106 2 46.9311 0.907751 40.3269 20.2628 20.9695 31.7148 +1107 4 47.0803 1.72619 37.5586 18.4264 -28.4903 17.3716 +1108 4 48.6288 0.838001 38.2574 -15.841 5.68773 -4.62102 +1109 4 45.6307 0.107149 38.6982 15.4635 0.946246 17.2142 +1110 4 48.0197 40.3992 39.8616 17.8935 -6.94949 10.1905 +1111 4 47.0012 39.8155 38.524 1.84183 3.03864 3.36861 +1112 4 46.2605 40.0937 40.1174 3.5183 -0.242765 2.2201 +1113 4 48.0596 1.05972 40.5786 -27.9597 -7.64804 -5.61245 +1114 4 46.4366 0.492644 41.2461 4.13191 -4.52617 -8.48469 +1115 4 46.5029 1.93558 40.2678 1.33797 -2.98423 -8.86627 +1116 1 46.1363 40.0225 35.9719 -11.8784 -48.163 0.632693 +1117 2 44.9067 39.2611 35.7716 22.3959 0.0668878 -14.2888 +1118 2 44.4049 38.8629 37.1725 -35.2322 11.6067 -22.5418 +1119 3 45.1472 38.486 38.0617 14.0918 -2.68919 9.70234 +1120 4 46.908 39.3425 36.1226 1.34088 13.782 2.29065 +1121 4 44.2497 39.8817 35.1331 -17.245 4.97255 12.4072 +1122 2 45.2366 37.985 34.8925 -4.99104 -6.23114 -9.17669 +1123 2 44.0069 37.0072 34.8313 5.26574 11.342 7.98842 +1124 2 45.6195 38.3915 33.4226 -3.76358 -20.0352 6.70883 +1125 4 46.1177 37.4383 35.3134 -3.76426 -1.15462 7.05426 +1126 4 43.5316 36.9313 35.8696 0.358942 -6.34703 -24.4349 +1127 4 44.3242 35.9956 34.5249 4.20531 -7.16171 2.34616 +1128 4 43.2753 37.3126 34.0403 -3.87397 3.42825 10.5933 +1129 4 46.6384 38.8467 33.4221 -3.79452 2.69366 -2.61982 +1130 4 44.9004 39.1304 33.0043 0.823619 -0.608417 -3.73086 +1131 4 45.6564 37.4663 32.7381 0.0287792 19.4258 11.3413 +1132 1 43.0561 38.9062 37.36 16.7964 -0.846157 38.4014 +1133 2 42.4272 38.5172 38.6279 -14.5421 -18.7427 13.0828 +1134 2 41.8753 37.0763 38.5124 -8.78692 12.5845 -64.2445 +1135 3 41.466 36.6885 37.3717 6.29707 6.96761 32.6735 +1136 4 42.3774 39.0214 36.6331 -15.2734 7.16413 -28.2079 +1137 4 43.1919 38.4467 39.4108 16.1917 0.0561369 8.47296 +1138 2 41.3404 39.5151 39.1514 -18.2527 2.1619 5.40726 +1139 2 42.0205 40.8503 39.6333 -29.5812 13.2835 -20.5362 +1140 2 41.0689 0.171231 39.4112 30.2059 17.4331 -9.29433 +1141 2 42.4678 40.816 41.1078 15.9246 -23.8206 -10.1516 +1142 4 40.688 39.0893 39.9799 16.7303 0.907162 -6.07322 +1143 4 40.5588 39.6983 38.3606 15.4269 0.857054 0.728379 +1144 4 42.8535 41.0549 38.9416 17.5291 -0.3509 1.61726 +1145 4 41.6271 1.1561 39.6676 -14.9721 -22.7636 -0.520954 +1146 4 40.1564 0.111331 40.0029 -13.6089 -0.269988 10.9836 +1147 4 40.76 0.320829 38.3386 1.94315 -8.64923 8.74761 +1148 4 41.6626 40.4848 41.7802 -9.99726 5.60483 6.07701 +1149 4 42.8258 41.8281 41.4135 4.90552 -5.57863 6.49728 +1150 4 43.2679 40.0127 41.241 -4.54696 19.1865 -0.92221 +1151 1 41.8233 36.2733 39.5754 -3.61756 -11.0936 16.9633 +1152 2 41.1922 34.957 39.6399 -10.4088 -17.6704 -50.7121 +1153 2 39.8412 35.0841 40.3193 -0.437683 4.39576 10.763 +1154 3 39.8144 35.4746 41.4864 -9.76 5.96233 -2.547 +1155 4 42.2323 36.5766 40.4577 6.86651 4.46574 10.4638 +1156 4 40.9934 34.6386 38.4963 8.65196 -1.15376 42.0164 +1157 2 42.0562 33.8903 40.4247 20.8855 33.0106 -9.02378 +1158 2 41.3005 32.6543 41 38.0556 15.2529 -12.1112 +1159 2 42.2217 31.3951 41.1067 -29.8496 -30.3433 -13.4218 +1160 1 43.3285 31.549 0.111927 13.7517 39.8644 23.5527 +1161 2 44.3839 30.7268 0.286736 21.6234 19.2182 17.9174 +1162 1 44.681 29.6113 41.5428 -25.8767 -16.3024 -25.7307 +1163 1 45.3493 31.1499 1.13058 -39.3833 23.49 -6.35183 +1164 4 42.617 34.5166 41.192 -12.3652 -23.3828 3.531 +1165 4 42.8948 33.5841 39.7601 -4.64767 -6.80459 -5.17496 +1166 4 40.4819 32.4474 40.3056 -13.8786 -11.9041 -4.8646 +1167 4 40.8645 32.9834 0.0421702 -8.7777 -8.2778 13.4879 +1168 4 42.5872 31.067 40.0872 -0.36901 12.0823 9.30135 +1169 4 41.553 30.5032 41.4129 16.6518 20.7036 2.18161 +1170 4 43.3615 32.497 0.627799 -1.11121 -36.4642 -14.6418 +1171 4 44.0326 29.3067 40.7749 11.9664 -0.606259 12.9296 +1172 4 45.4908 28.9966 41.7635 -4.5997 7.04477 0.652143 +1173 4 45.2947 32.0222 1.6989 -3.32167 -9.1207 -8.17541 +1174 4 46.1369 30.5772 1.3332 29.28 -20.6173 7.21336 +1175 1 38.7318 34.7203 39.6307 -5.56998 -4.40152 -32.2775 +1176 2 37.3555 34.7738 40.1542 17.1032 1.0045 -6.37855 +1177 2 37.2353 33.667 41.1913 -33.3614 37.0741 40.0449 +1178 3 37.7005 32.5636 40.9891 18.731 -32.0974 -3.65368 +1179 4 38.8335 34.3404 38.6486 -6.51334 12.5121 23.5529 +1180 4 37.2672 35.7762 40.6273 -9.086 1.46109 5.84779 +1181 2 36.2453 34.5638 39.0845 -6.93832 -9.37108 -7.97374 +1182 2 36.1701 35.614 37.9414 8.91404 15.2365 -6.3275 +1183 2 35.3527 35.0344 36.7472 39.8054 8.21108 -27.9 +1184 2 35.4841 36.9314 38.4139 -18.287 13.7727 -16.8718 +1185 4 35.232 34.5024 39.5744 7.45292 -0.257102 0.0904576 +1186 4 36.3852 33.5433 38.6164 0.781265 7.17557 6.89015 +1187 4 37.2115 35.9047 37.5843 -11.2451 -10.8797 5.10717 +1188 4 35.5662 35.6385 35.778 -16.1675 -5.48794 25.897 +1189 4 34.291 34.967 37.0013 -15.7304 -0.876038 -4.35202 +1190 4 35.7074 34.0135 36.4456 -4.10332 3.28733 9.08934 +1191 4 35.4655 37.7439 37.5577 -4.97646 -27.0735 23.6494 +1192 4 36.0148 37.4196 39.237 12.1669 1.46201 8.99598 +1193 4 34.4369 36.7462 38.8365 16.8945 3.16641 -16.172 +1194 1 36.5334 33.9935 0.435925 10.1465 7.38421 -15.9691 +1195 2 36.4058 33.2568 1.6875 16.4821 -29.3274 -13.0782 +1196 2 35.1468 33.6833 2.42741 -3.52585 26.4938 2.22063 +1197 3 34.7699 34.8785 2.50349 9.50092 -20.8144 -9.83338 +1198 4 35.9506 34.8486 0.439937 7.33038 -6.12466 -5.51472 +1199 4 36.3499 32.1247 1.42412 1.62075 26.2077 7.36918 +1200 2 37.675 33.5505 2.58336 -0.681506 -6.35683 7.58589 +1201 2 37.7854 32.6927 3.8625 18.6921 -17.668 32.0141 +1202 2 39.0575 32.9332 4.76873 14.2724 -20.5826 -30.9069 +1203 1 39.1289 34.2491 5.33109 11.0713 19.2422 13.5273 +1204 2 40.0441 34.6938 6.2528 -38.5124 5.77538 -21.346 +1205 1 41.0523 34.0015 6.75388 -9.3068 -30.315 -40.8639 +1206 1 39.7573 35.8959 6.75045 4.65044 -37.6482 -19.533 +1207 4 37.7117 34.6025 2.94212 -4.78803 6.98284 -11.1897 +1208 4 38.6033 33.3783 1.98429 -1.50456 2.19712 -0.683264 +1209 4 37.8193 31.5994 3.65006 -4.42508 0.799529 -11.9295 +1210 4 36.9318 32.7949 4.56147 -11.5542 5.52665 -5.70323 +1211 4 39.9727 32.6563 4.13477 -10.3426 12.9457 13.0222 +1212 4 39.0991 32.232 5.62646 -6.41615 -9.9444 -1.6393 +1213 4 38.3112 34.8566 5.12728 9.08197 -0.1797 3.06874 +1214 4 41.338 33.0965 6.26824 1.29043 26.2885 21.8424 +1215 4 41.5567 34.3995 7.53172 18.6054 -2.34736 15.9895 +1216 4 38.9283 36.4191 6.51463 -17.6749 8.57537 -7.4588 +1217 4 40.3535 36.2619 7.44459 24.2502 25.7988 36.1589 +1218 1 34.4423 32.7029 2.99518 -5.91218 -18.2551 8.17758 +1219 2 33.2643 32.9205 3.78866 2.14491 3.18155 15.0212 +1220 2 32.3114 31.74 3.93685 27.6029 1.93064 -50.2862 +1221 3 31.6521 31.6162 4.95167 -20.1995 -6.42992 23.3772 +1222 4 34.7506 31.7123 2.9878 2.11082 4.57648 -1.08475 +1223 4 33.5885 33.2179 4.82725 -4.56531 -3.45872 -11.3922 +1224 4 32.6993 33.791 3.40271 -6.19117 1.50996 -1.33542 +1225 1 32.2733 30.8792 2.86255 -3.44833 -0.807911 26.2314 +1226 2 31.5067 29.6456 2.87911 -22.6819 -12.0155 6.38652 +1227 2 32.0275 28.5204 1.99364 -17.4826 -15.7648 -26.1521 +1228 3 31.24 27.9052 1.1757 18.2868 13.9435 17.0259 +1229 4 32.9257 31.0189 2.07167 -6.99587 -10.4877 -2.31778 +1230 4 31.4409 29.1882 3.92659 1.7726 14.0477 -11.6562 +1231 4 30.4172 29.8482 2.57519 20.7941 0.876843 7.98191 +1232 3 33.2432 28.1769 2.02662 6.75216 10.2675 5.6015 +1233 6 29.6689 33.0345 2.6027 6.39732 3.7635 -6.59735 +1234 4 28.7656 33.0857 2.95028 -0.371973 -14.4593 -6.85361 +1235 4 29.8153 32.1814 2.14015 -8.59972 11.6466 4.8732 +1236 6 1.91326 24.7635 28.0772 5.65317 -6.35183 16.4854 +1237 4 1.01929 24.4316 28.2568 3.94453 1.46201 -0.938269 +1238 4 2.46517 24.4471 28.8255 -6.59296 2.11781 -11.8027 +1239 6 8.98979 35.4216 7.06427 2.13264 0.908259 -3.07356 +1240 4 8.22375 36.0041 6.95701 -0.608539 -3.26387 0.365744 +1241 4 9.74616 35.991 6.87666 4.70766 2.91314 -0.442423 +1242 6 37.9357 35.2342 23.5273 -23.102 9.18642 19.8247 +1243 4 37.5041 35.2968 22.6705 0.513901 -3.82007 -8.89977 +1244 4 38.8432 35.0218 23.4038 20.8563 -8.17935 -11.4372 +1245 6 11.3793 34.6137 20.3253 14.1507 4.32837 -4.20952 +1246 4 10.4755 34.624 20.6003 -22.0831 6.77293 1.73618 +1247 4 11.7264 33.9016 20.8561 13.9299 -11.0914 4.04985 +1248 6 3.06607 13.1144 13.5167 22.577 18.8722 18.6067 +1249 4 2.20388 12.8262 13.8046 -7.02328 -4.57126 0.810516 +1250 4 3.32154 13.8092 14.1761 -2.44089 -14.0351 -15.8923 +1251 6 9.17443 22.3777 24.8954 -7.42914 3.56866 8.74917 +1252 4 9.07626 22.0242 24.0039 2.26474 -2.4656 -3.7019 +1253 4 8.26912 22.4958 25.2295 3.15193 -1.43545 -3.27774 +1254 6 31.1464 36.1236 7.45234 10.6607 -18.1227 -24.2194 +1255 4 30.9334 35.2222 7.12747 -5.34615 12.6105 12.538 +1256 4 31.8314 36.3443 6.79825 -5.43643 8.62165 8.26122 +1257 6 20.3227 0.172698 30.1419 10.3105 -3.05703 7.76208 +1258 4 20.0388 1.0684 29.8874 5.3247 -3.32009 0.781739 +1259 4 21.2583 0.228399 30.4322 -11.2768 6.47679 -5.28094 +1260 6 32.6859 3.01778 5.15829 -10.6028 -19.0303 43.6625 +1261 4 32.0356 2.3058 5.02019 7.54008 9.83835 -8.28794 +1262 4 32.7128 3.00557 6.15578 5.12118 6.62375 -23.7252 +1263 6 26.2374 8.27856 11.5971 17.869 0.788073 20.0593 +1264 4 26.2346 7.39991 12.0216 -0.142457 7.42091 -4.28305 +1265 4 26.8978 8.79254 12.1302 -17.5189 -15.6641 -18.5798 +1266 6 1.09614 20.2561 0.875192 -22.9747 0.467748 19.1373 +1267 4 0.851949 19.3199 1.10255 19.4844 20.3298 -11.3195 +1268 4 1.85437 20.3448 0.297385 12.1513 -16.76 -9.59627 +1269 6 29.1514 22.9126 1.42851 -3.57267 15.5796 12.2113 +1270 4 28.6966 23.7416 1.67141 5.52941 -12.1705 -9.88265 +1271 4 29.6634 22.7027 2.22543 0.165437 -2.26551 -2.85175 +1272 6 34.1399 34.826 6.47271 -4.00425 12.5535 -7.93856 +1273 4 34.8635 34.3401 6.10458 13.259 -3.54932 -9.87122 +1274 4 33.9387 34.3337 7.25184 -8.28913 -2.66912 16.7304 +1275 6 25.1643 37.1931 26.5228 17.2229 -22.0393 -23.1844 +1276 4 24.6935 37.7676 27.1042 -4.31343 22.2846 18.4719 +1277 4 26.0117 37.6203 26.271 -7.79876 5.52479 6.28113 +1278 6 14.5333 22.2337 15.6719 -21.8235 -40.5779 4.16881 +1279 4 14.0435 21.3187 15.7268 23.5152 50.9834 -4.51283 +1280 4 14.2451 22.7392 14.8947 -1.224 -10.8945 3.63574 +1281 6 2.86145 5.86342 4.09514 -12.0928 12.5672 -7.55007 +1282 4 3.31871 5.53612 4.87755 -0.114002 3.3263 11.1441 +1283 4 2.36891 6.69134 4.30817 11.5092 -15.7361 4.93451 +1284 6 27.6072 26.7133 22.7037 11.3111 -21.4893 35.9413 +1285 4 26.8221 26.1673 22.7712 -7.10606 -4.70529 -2.97044 +1286 4 27.5145 27.2572 21.9514 -10.0855 20.8317 -32.7258 +1287 6 17.7799 0.609907 22.4001 -5.17757 10.6635 4.04288 +1288 4 17.0763 0.657064 23.0885 11.5181 4.04392 -9.91171 +1289 4 18.0806 1.5364 22.261 -7.85301 -10.5281 2.59652 +1290 6 8.08893 9.42761 10.5595 3.55537 5.25916 40.324 +1291 4 7.89361 10.322 10.3179 -9.19974 15.7377 -19.3495 +1292 4 8.16563 9.56196 11.5399 2.2102 -21.2534 -20.7584 +1293 6 15.3508 8.71886 30.755 5.09068 -14.416 21.7005 +1294 4 15.721 8.98141 29.9127 -5.17651 10.4904 -11.2194 +1295 4 14.5411 9.19598 30.997 6.64715 3.62724 -9.30987 +1296 6 11.0273 17.2714 37.5546 -8.62993 4.63856 -3.16721 +1297 4 10.646 18.1523 37.5049 13.3861 11.3255 -4.88271 +1298 4 10.2437 16.8378 37.8681 -2.55755 -24.0409 7.53141 +1299 6 42.0954 25.1585 20.3881 14.6842 1.84925 -24.6227 +1300 4 41.6997 25.8318 19.7943 -2.16553 -3.48259 16.6789 +1301 4 41.6994 25.1952 21.2528 -9.02961 7.39914 10.888 +1302 6 25.8656 4.70522 33.8434 4.94337 -17.9304 30.0995 +1303 4 25.7948 4.41246 32.9437 -1.56424 4.53154 -20.9619 +1304 4 25.7821 5.65919 33.9019 -2.93726 10.638 -9.31877 +1305 6 28.7565 10.7943 24.343 5.31048 -5.66707 -17.5237 +1306 4 29.0395 10.691 25.2776 6.61806 -8.7001 -20.887 +1307 4 29.3174 10.2678 23.7025 -8.86987 6.64124 26.5787 +1308 6 5.00601 41.813 11.1 6.11697 -35.3303 28.6791 +1309 4 5.97939 41.6679 11.0741 -12.7816 8.03831 -2.02432 +1310 4 4.68345 41.1078 11.7429 5.5471 25.1349 -25.8779 +1311 6 51.7607 12.785 30.1531 41.9873 7.8243 6.58168 +1312 4 51.5044 13.1989 29.3224 -3.76645 3.26875 -7.63234 +1313 4 52.7548 12.9452 30.2104 -29.821 -7.22149 1.35463 +1314 6 7.60527 6.19156 6.53697 16.5093 0.883216 -0.386471 +1315 4 6.7728 6.50088 6.91441 -4.77803 -9.70632 -1.71599 +1316 4 7.48617 5.31021 6.15237 -11.2115 3.19853 1.4886 +1317 6 14.6639 26.9856 30.1439 5.75321 15.8705 11.2484 +1318 4 14.5566 27.0259 31.1175 -3.12227 -7.05885 -13.9758 +1319 4 15.1715 27.7926 29.9326 -6.11328 -7.83436 0.701957 +1320 6 15.3386 3.73742 21.1629 -49.5233 -4.42818 1.41573 +1321 4 14.7513 4.15862 21.8308 22.5595 -2.74077 -5.2282 +1322 4 14.679 3.20837 20.6508 28.7222 9.19721 3.95726 +1323 6 18.6168 30.4391 6.46727 22.6827 -23.6706 30.2016 +1324 4 19.0357 29.7477 7.08277 -19.2097 26.0479 -21.7287 +1325 4 19.3376 31.0911 6.37388 -10.7119 -2.89972 -1.77141 +1326 6 40.7683 1.30949 12.8061 -7.58564 4.37034 -9.51004 +1327 4 39.8743 1.70123 12.8539 8.02325 -2.8267 0.614513 +1328 4 41.1302 1.62292 11.9594 1.79027 -4.37486 1.66609 +1329 6 17.747 20.7401 41.5828 -14.5708 23.9699 -22.25 +1330 4 16.8287 21.1121 41.5273 18.852 -12.8662 8.2158 +1331 4 18.269 21.3043 40.983 -0.296974 -7.34806 11.4382 +1332 6 20.4522 2.1467 12.3338 -13.8993 16.4183 -18.7538 +1333 4 19.8428 1.38545 12.4588 7.32118 14.6694 -7.56396 +1334 4 20.1591 2.61844 11.4836 4.96023 -26.6086 29.2353 +1335 6 9.8437 37.1731 18.0697 32.5344 -3.69518 -7.02483 +1336 4 9.9915 37.607 18.9153 -11.6933 2.16478 7.61773 +1337 4 10.7629 37.1686 17.7045 -22.2666 -4.61022 -1.39483 +1338 6 22.8273 7.39987 18.8956 -5.5011 7.28813 -36.492 +1339 4 23.2632 7.84344 18.1165 -7.98371 -8.25387 20.5209 +1340 4 21.8866 7.2843 18.6392 14.3432 0.686453 4.84686 +1341 6 12.8601 6.85899 39.0577 6.92589 -13.3495 -12.6124 +1342 4 12.2887 7.60854 39.1608 -14.8411 14.7282 0.271429 +1343 4 13.3423 6.79713 39.8797 5.00888 -0.905409 12.2129 +1344 6 10.1643 2.40912 23.2548 -13.4149 21.1074 -1.06732 +1345 4 10.2774 2.03439 22.3894 8.18098 -13.9841 -15.6202 +1346 4 9.49692 3.09648 23.049 6.99386 -4.39158 13.7206 +1347 6 12.5495 20.2147 19.5723 7.26787 8.21028 -18.3895 +1348 4 11.6895 19.7983 19.735 -1.5185 0.18686 -8.43892 +1349 4 12.6119 20.404 18.6017 -2.05058 -6.51038 26.2392 +1350 6 53.8702 6.35891 18.9198 29.7306 -6.18586 8.10346 +1351 4 53.0457 6.06715 19.2818 -21.258 -2.7468 0.110915 +1352 4 54.4788 6.08079 19.6257 -1.29631 10.1734 -11.3531 +1353 6 1.76233 4.00968 13.2412 15.2049 -20.178 -6.82767 +1354 4 1.1126 4.5015 13.7221 -14.7745 7.27862 5.55391 +1355 4 1.46634 3.0803 13.3195 6.22895 8.64986 -3.00031 +1356 6 2.68809 16.4658 4.58471 15.0105 -8.44828 17.4213 +1357 4 3.47968 16.3912 5.17607 -18.0483 5.65918 -16.5792 +1358 4 2.952 17.0668 3.88721 1.61121 4.43717 -9.18758 +1359 6 22.6412 7.38905 35.0491 -42.342 -19.7774 -51.2585 +1360 4 21.8701 7.10292 34.411 47.7649 22.3984 34.2121 +1361 4 22.4927 6.7758 35.7601 0.300803 -9.30322 17.5195 +1362 6 30.6449 27.8966 19.9 11.2186 24.5725 -17.4668 +1363 4 31.067 28.6028 19.3405 -15.311 -24.4133 12.7333 +1364 4 30.0502 27.364 19.3383 6.18265 4.0422 4.40167 +1365 6 18.3584 9.54031 6.21119 11.0026 -3.68808 23.2716 +1366 4 18.3645 9.12256 5.3612 -2.33489 -5.22153 -19.3682 +1367 4 19.1216 9.13552 6.66909 -8.40358 6.03455 -2.63927 +1368 6 21.0207 30.3946 30.8361 -20.2261 -14.3153 8.76877 +1369 4 21.7305 31.0371 30.8947 0.539155 4.23503 10.2216 +1370 4 20.6128 30.1908 31.727 18.9681 11.2591 -24.4987 +1371 6 28.3223 4.36971 15.0862 0.785553 22.566 1.53388 +1372 4 27.9162 3.53142 15.2341 -13.4814 -22.4749 6.99245 +1373 4 29.0547 4.16931 14.5133 14.7433 -0.183871 -4.75122 +1374 6 12.7699 0.652736 16.5284 -10.9622 36.0111 -3.70833 +1375 4 13.1417 1.43405 17.0195 -7.22472 -23.339 -11.6266 +1376 4 12.1312 1.03058 15.8629 17.1298 -5.78525 17.4901 +1377 6 27.5613 35.204 8.24204 -17.5468 -3.17574 2.50179 +1378 4 28.0037 35.3359 7.41158 3.58667 2.22765 -10.9792 +1379 4 26.8513 34.5538 8.04841 12.0719 12.2779 8.55847 +1380 6 24.0727 5.16129 41.0114 25.3265 34.0312 4.62534 +1381 4 24.5764 6.00631 41.0278 8.83913 -22.6202 16.662 +1382 4 23.4512 5.41721 40.3589 -27.9927 -11.5371 -21.4854 +1383 6 16.8577 24.9409 28.3044 -13.362 20.9446 -8.34262 +1384 4 15.8529 24.9248 28.4711 42.0709 9.51562 -15.4474 +1385 4 17.0929 25.6637 27.6385 -20.1406 -20.6283 22.1367 +1386 6 20.8367 12.7872 17.016 48.1357 -13.7972 -0.957512 +1387 4 20.9831 13.7012 17.3244 -4.24853 -6.44611 -2.53838 +1388 4 21.7731 12.3998 16.8344 -46.2893 13.5674 8.59046 +1389 6 35.7698 23.0286 30.9167 1.31549 -8.15919 10.0357 +1390 4 34.8007 23.0783 30.9694 4.38358 -0.634017 0.107585 +1391 4 36.0504 22.6611 31.7855 -2.79806 7.45108 -14.1947 +1392 6 36.3049 21.4 25.8723 16.8231 15.2703 -10.059 +1393 4 35.3849 21.2313 25.7163 -23.5769 -6.11261 -4.10927 +1394 4 36.6855 20.6326 26.2849 5.24534 -13.4215 6.45433 +1395 6 13.4896 6.74946 5.28081 -28.3592 57.2786 25.4238 +1396 4 13.8414 6.02988 4.86679 44.4058 -71.9847 -33.7479 +1397 4 12.7199 6.9047 4.75258 -19.8414 9.95147 -1.72496 +1398 6 20.8046 20.4221 13.7595 5.24729 11.8597 -23.4966 +1399 4 21.3314 20.3763 14.5586 1.04488 -1.4591 8.76088 +1400 4 19.8874 20.2651 13.9627 -8.54986 -4.70556 7.47732 +1401 6 20.3763 29.1306 1.39291 -22.654 9.61717 24.1604 +1402 4 20.4714 29.8874 2.01179 2.99602 -8.49852 -9.62387 +1403 4 19.4639 28.7985 1.61052 22.0838 3.18086 -13.1329 +1404 6 50.878 13.1268 37.2744 -6.92527 18.9089 19.2141 +1405 4 51.431 12.5903 37.8743 -5.40112 9.96959 -2.47836 +1406 4 50.5327 13.8902 37.8162 10.8793 -23.2499 -13.6212 +1407 6 33.933 34.1706 20.4988 -24.935 23.2996 -4.02345 +1408 4 33.9537 34.3969 19.5503 3.97405 -5.2202 10.173 +1409 4 33.1424 34.6907 20.8306 20.6842 -17.0796 -4.50693 +1410 6 26.2139 28.0427 27.5441 -18.3219 -6.87449 2.92541 +1411 4 26.6233 28.4264 28.3298 2.52406 0.509022 -5.28732 +1412 4 25.2474 28.0355 27.7473 15.6982 -2.70826 -9.65401 +1413 6 7.68199 21.3044 4.2899 -23.4352 7.97399 30.3744 +1414 4 8.39223 20.9571 3.80392 40.3202 -21.1106 -20.5498 +1415 4 7.23721 21.8696 3.67656 -12.7303 12.1883 -10.427 +1416 6 21.997 15.1678 5.91921 0.156106 10.1967 -8.47357 +1417 4 22.4631 15.3078 5.09012 1.49736 10.8302 -2.43488 +1418 4 21.9323 14.2285 5.99467 -4.63281 -19.7734 10.7123 +1419 6 21.7161 24.0028 3.81129 14.7157 -6.77156 -2.79544 +1420 4 22.6514 24.278 3.99089 -16.266 -7.57571 -5.80044 +1421 4 21.7278 23.1773 3.27349 4.3704 10.7286 8.25651 +1422 6 11.5654 23.7677 12.5675 4.34126 23.9889 5.0328 +1423 4 11.8179 24.711 12.3772 -5.51197 -27.812 -0.203907 +1424 4 11.194 23.7871 13.4529 -2.51135 -1.17837 2.27349 +1425 6 32.365 18.0609 29.8133 5.42876 1.07285 10.0727 +1426 4 33.2855 17.8495 29.9872 2.18588 2.92383 8.75228 +1427 4 32.2516 17.686 28.9464 -9.45666 -7.03173 -17.6671 +1428 6 9.26057 12.3901 30.3108 6.69251 -5.93803 -6.45383 +1429 4 8.9331 13.0089 30.9751 -1.99931 -0.452864 0.983921 +1430 4 10.127 12.0766 30.6488 -15.6011 7.03664 -5.16285 +1431 6 40.1575 25.9297 9.14135 -21.3024 -7.39617 3.31146 +1432 4 40.7828 25.2448 9.36979 6.64832 -8.60816 0.262948 +1433 4 40.6901 26.6937 8.96671 10.3695 18.4246 -3.8085 +1434 6 43.1786 32.337 37.3292 -33.551 -18.2832 -9.28851 +1435 4 42.7165 32.8749 36.6701 14.8891 8.67062 4.46068 +1436 4 42.4294 31.7351 37.5575 24.0939 3.67107 5.33039 +1437 6 44.0961 6.28371 31.2632 9.51948 -8.69332 -33.5784 +1438 4 43.4914 6.92213 31.6058 -15.4833 19.2503 12.9198 +1439 4 44.559 5.89005 31.9835 8.76633 -8.79917 23.1113 +1440 6 10.2083 18.8859 19.6919 15.5822 -2.80816 -8.35433 +1441 4 10.2079 18.3466 20.4907 -1.18434 0.124911 0.125127 +1442 4 9.35433 19.315 19.665 -12.7717 3.54701 3.24565 +1443 6 7.05259 15.5816 15.0277 -11.6868 16.7681 -20.4125 +1444 4 7.21112 15.523 14.0697 -0.749561 -1.2692 3.08306 +1445 4 7.39122 14.7797 15.3874 7.84577 -24.8334 9.86289 +1446 6 24.5366 3.48359 27.8583 16.7503 5.69766 5.18976 +1447 4 23.7024 3.43271 28.3539 -4.73503 -2.50774 -10.2909 +1448 4 24.4259 3.10654 26.9763 -12.6917 -5.22111 2.5626 +1449 6 54.3931 31.8073 9.72289 -3.19054 17.1237 19.0803 +1450 4 53.9641 31.62 8.89214 -6.37727 -2.00813 -13.4715 +1451 4 54.1243 32.7301 9.92854 3.65429 -15.124 -2.64791 +1452 6 6.79493 17.0949 36.2025 -8.81624 7.47492 14.5397 +1453 4 5.9165 16.6466 36.2092 18.1356 5.91394 -12.2869 +1454 4 7.21103 17.1598 35.3293 -13.3551 -7.88765 -1.67162 +1455 6 28.633 7.46221 20.4165 -21.0133 14.9556 -29.8407 +1456 4 27.7506 7.6389 20.7846 4.83271 -6.12746 3.71795 +1457 4 28.5316 7.77661 19.4783 9.56717 -7.40103 22.9991 +1458 6 17.0376 1.7027 8.35788 5.34968 28.5352 32.0038 +1459 4 17.0661 0.753124 8.28199 -2.4228 -14.8367 -20.8379 +1460 4 16.762 2.22772 7.59129 -1.56258 -15.3605 -8.12812 +1461 6 19.1384 19.3343 35.5751 19.5023 3.30605 7.15282 +1462 4 18.4451 18.7061 35.4179 -10.2251 -8.92118 -4.92207 +1463 4 19.8852 18.808 35.914 -3.54436 4.66685 -0.605832 +1464 6 7.31639 31.3666 13.5695 -43.9944 -20.214 -21.2721 +1465 4 6.78612 30.574 13.8569 21.4883 17.7075 -0.698983 +1466 4 6.68503 31.7843 12.9295 22.0056 -0.349161 9.64417 +1467 6 16.674 5.24419 12.8556 -11.0373 -33.5815 5.02698 +1468 4 17.465 5.75961 12.9546 20.2971 3.5869 6.63236 +1469 4 16.7677 4.34295 13.2785 1.53127 21.9447 -10.2143 +1470 6 43.8803 12.7494 34.5747 -22.4085 -20.9808 -0.0671255 +1471 4 43.9515 13.6536 34.2548 -4.30422 8.76569 -3.51904 +1472 4 42.9542 12.429 34.42 18.6754 8.57765 -0.433924 +1473 6 42.6607 36.4569 28.5239 -16.8168 -12.4187 2.20896 +1474 4 42.172 37.2929 28.6321 13.9601 -3.78206 -4.91178 +1475 4 43.5913 36.5775 28.2923 4.62592 13.2896 -0.105187 +1476 6 35.3772 15.0586 6.04009 27.912 48.9275 -7.18458 +1477 4 35.887 15.8982 5.7897 -19.1126 -32.2788 12.1212 +1478 4 34.8045 14.9281 5.27735 -5.52923 -7.04807 -1.55591 +1479 6 19.4078 5.85855 6.1829 -40.2001 -18.9085 -3.31614 +1480 4 18.5441 5.99364 6.63156 8.43156 -9.10613 -8.3884 +1481 4 19.928 6.53616 6.54489 31.8426 31.4232 15.0663 +1482 6 29.261 38.1682 6.98131 -37.2303 32.1811 -6.57247 +1483 4 28.4837 38.0966 7.57517 15.5489 -1.40449 -6.41795 +1484 4 29.8842 37.5088 7.21603 19.671 -25.1607 10.5683 +1485 6 19.357 26.1782 8.47801 4.74765 -18.9961 17.9486 +1486 4 19.3733 25.7814 9.38274 -2.97831 10.6699 -17.265 +1487 4 20.1618 25.7953 8.09114 -4.76457 3.34604 0.730176 +1488 6 4.92328 16.6713 6.1398 7.47336 5.27851 2.26954 +1489 4 5.50113 17.3858 5.8203 -2.76896 -2.40075 1.51866 +1490 4 5.42288 15.8417 6.02573 -4.96937 12.5626 -0.560722 +1491 6 6.06184 16.6875 28.0703 25.9558 6.64688 1.10321 +1492 4 5.15824 16.4097 27.9597 -16.212 -5.66481 -14.185 +1493 4 6.48748 16.8231 27.1848 -21.9791 -6.00697 19.2504 +1494 6 21.7362 29.3702 22.1089 -17.2737 20.913 34.8846 +1495 4 21.4452 30.3289 22.1112 6.19611 -27.0689 0.469942 +1496 4 21.3293 28.9728 22.9428 14.5469 12.9694 -26.9427 +1497 6 24.4985 0.540505 12.8515 12.2489 -9.36427 2.95715 +1498 4 24.0437 0.939092 12.114 -3.50986 5.42614 -10.4761 +1499 4 24.1106 0.99496 13.5957 -0.561841 3.41965 12.163 +1500 6 18.4019 28.2584 40.3145 -11.401 19.5033 -15.6681 +1501 4 18.3886 27.6361 41.0165 -1.05122 -20.6036 22.2694 +1502 4 19.1831 28.024 39.826 8.23901 2.08545 -8.43276 +1503 6 10.3826 17.4565 21.9113 1.92941 -13.2413 3.45357 +1504 4 9.8824 16.6205 21.8349 3.82121 7.52813 2.02092 +1505 4 9.93899 17.9725 22.5913 -5.82795 2.16988 4.16556 +1506 6 13.5489 13.3588 39.6353 11.9209 29.8927 39.0415 +1507 4 13.8427 14.2544 39.3649 -8.64321 -16.3346 -3.85104 +1508 4 13.5548 13.4385 40.6332 -1.97454 -11.1079 -31.9482 +1509 6 19.5449 26.0093 24.7389 -52.2633 13.2593 -7.73686 +1510 4 19.57 25.3975 24.0097 10.2262 -10.7296 -10.4349 +1511 4 20.3304 26.0184 25.2393 35.6126 -10.3894 17.1361 +1512 6 8.93096 25.8929 20.0882 -7.71251 -64.4566 3.30388 +1513 4 8.30787 26.3938 20.5887 -11.4685 32.8171 11.63 +1514 4 9.62246 26.3511 19.648 20.7791 34.2926 -13.3665 +1515 6 13.4555 41.2072 30.5108 -10.8988 -15.928 5.69795 +1516 4 14.2767 41.1294 31.0436 -12.4449 -5.39064 -3.38157 +1517 4 12.7718 40.5451 30.8276 25.6688 18.9533 -5.69319 +1518 6 21.165 21.6707 11.1126 6.53241 11.8742 3.94385 +1519 4 20.8889 20.8699 10.6872 -6.5221 -17.8932 -11.6656 +1520 4 21.171 21.4318 12.0451 -0.673303 -0.892159 6.0991 +1521 6 43.5659 10.3222 15.565 -2.18625 -17.2881 -4.53442 +1522 4 43.269 9.50121 15.139 10.696 3.36153 7.59808 +1523 4 42.8911 10.937 15.2983 -10.0921 17.3133 -0.93945 +1524 6 23.5255 5.06673 12.3063 -8.27451 55.1521 -7.02327 +1525 4 23.4703 4.15364 12.096 -5.93718 -33.8878 -14.7403 +1526 4 23.077 5.57318 11.5535 15.1023 -26.9196 22.8331 +1527 6 9.29314 15.4001 4.25145 -3.86255 -4.02248 -25.5662 +1528 4 8.9509 16.1187 4.78154 1.1615 8.22379 13.6068 +1529 4 9.97933 14.9549 4.74249 8.84801 0.0887981 11.7331 +1530 6 26.7067 10.8779 17.5788 3.55047 -19.7627 -22.9275 +1531 4 26.5537 10.995 18.4988 -3.13636 8.79354 30.8805 +1532 4 26.79 11.729 17.1566 -1.16375 6.51516 1.16674 +1533 6 26.0497 23.6027 33.6801 19.5894 25.2732 20.1931 +1534 4 25.4452 23.9936 33.0304 1.52608 5.68176 -1.06817 +1535 4 26.6384 24.3139 34.1277 -30.0139 -24.8801 -23.6693 +1536 6 7.5709 10.5028 28.9083 -0.962228 -19.583 -21.6711 +1537 4 6.74329 10.4799 29.4005 3.80738 8.46019 8.36633 +1538 4 8.19878 11.0832 29.3397 0.629116 8.24646 12.7121 +1539 6 16.498 16.9072 24.6485 7.82025 23.6222 16.3151 +1540 4 16.0345 17.7596 24.5588 5.31695 -3.73313 -0.390286 +1541 4 16.1792 16.4208 23.9083 -7.11448 -16.9587 -21.9433 +1542 6 12.549 12.7866 0.448591 8.35618 6.39845 34.9671 +1543 4 12.9768 12.9146 1.38779 -15.5602 -17.6496 -50.0052 +1544 4 12.7689 11.9205 0.0349689 0.659473 7.36742 13.3893 +1545 6 6.80731 2.45617 9.05869 -7.23501 -7.03372 -0.578084 +1546 4 7.10343 3.02287 9.78944 7.77528 -6.31722 -2.26682 +1547 4 7.3272 1.63733 8.99034 2.01029 5.74015 6.94656 +1548 6 28.8877 11.8706 12.0154 41.6386 34.6329 -2.99516 +1549 4 28.2108 12.4771 11.6895 -6.34049 1.49886 1.56166 +1550 4 29.7533 12.3393 11.8008 -29.7579 -18.4108 8.17464 +1551 6 44.6745 32.5962 29.7139 -34.2161 4.66467 6.73964 +1552 4 43.7628 32.9784 29.4642 35.9402 -16.1761 10.2258 +1553 4 44.5125 31.9002 30.3967 -1.3182 18.2082 -15.8911 +1554 6 28.5995 15.1068 32.2872 13.2766 -51.3111 -20.1848 +1555 4 29.0279 15.8582 31.8991 2.31019 19.0875 -3.40369 +1556 4 29.0943 14.3419 31.8537 -21.7517 23.8731 20.1718 +1557 6 1.14062 22.1898 33.6289 -39.3586 14.574 19.5436 +1558 4 0.65227 22.798 33.0535 3.91391 -2.7929 6.08546 +1559 4 1.82717 21.8879 33.088 34.4042 -16.5957 -27.8984 +1560 6 17.4513 16.8201 9.93098 -1.82085 -23.3459 26.2514 +1561 4 17.8906 17.1746 9.18159 7.86355 15.3521 -22.135 +1562 4 18.0267 16.0779 10.2085 -7.73246 7.19916 -1.96586 +1563 6 18.7435 29.8048 14.4095 21.7061 -3.72347 40.0221 +1564 4 19.5652 29.5706 14.9087 -19.4331 3.67999 -8.42588 +1565 4 18.9661 29.6909 13.4944 1.97037 -1.23698 -19.2163 +1566 6 39.4071 6.51101 13.0179 12.0574 6.81682 -11.0022 +1567 4 39.7785 7.30288 12.5709 -10.193 -11.7897 7.6563 +1568 4 39.9532 5.78104 12.6849 -4.03584 4.98089 5.48617 +1569 6 54.0977 38.2821 14.3159 8.76467 -13.509 23.2458 +1570 4 53.5116 38.6447 15.0061 0.0542658 1.01747 -18.4972 +1571 4 53.8554 38.6311 13.4594 -12.9742 11.219 -5.93773 +1572 6 7.52036 32.013 20.9427 34.362 14.2167 21.5407 +1573 4 7.05735 31.9924 20.1252 -18.8869 -6.37038 -21.2822 +1574 4 7.04171 31.4816 21.5607 -16.1882 -11.3569 11.099 +1575 6 26.965 15.5039 13.8257 -10.8147 -22.3452 14.7237 +1576 4 27.2177 14.7358 14.3683 8.65177 6.42067 -5.59001 +1577 4 26.0429 15.6169 14.0906 -6.80859 9.66341 -6.51148 +1578 6 18.3782 16.4473 32.1249 -4.95226 -1.86998 -9.87987 +1579 4 18.1426 16.6374 31.1969 4.73263 -0.719504 8.39792 +1580 4 19.0836 17.0573 32.3614 6.73072 6.57595 -2.73442 +1581 6 52.4873 31.678 23.2415 -44.1119 -6.58328 47.4356 +1582 4 52.4708 32.2686 24.0415 7.23299 -8.75358 -21.8316 +1583 4 53.1739 31.883 22.645 31.3465 14.6123 -23.9869 +1584 6 2.16824 9.71317 28.2162 5.46837 -18.1801 7.45826 +1585 4 2.48183 10.5213 27.7929 -7.61484 8.72751 3.65687 +1586 4 1.37959 9.87032 28.768 3.44281 10.2362 -4.06622 +1587 6 32.9194 0.0905733 22.5781 10.5432 -20.5017 -7.42813 +1588 4 33.2395 41.1185 22.3208 -17.3926 6.61176 1.08087 +1589 4 33.7441 0.505918 22.8191 5.29332 16.1982 3.6992 +1590 6 20.7309 41.5697 38.6372 28.3147 -14.9122 -44.687 +1591 4 20.0328 41.0591 39.0281 -13.7779 -1.58578 11.2509 +1592 4 21.0348 40.9602 37.8857 -7.98591 29.4899 32.1121 +1593 6 43.3035 24.332 12.1458 11.7575 -1.61212 -4.71191 +1594 4 43.2118 25.2792 12.3722 8.64503 -11.1136 -9.01316 +1595 4 44.1249 24.1975 11.6011 -17.6772 13.9566 14.4164 +1596 6 22.028 36.2965 11.8178 -12.5217 11.0116 -6.64335 +1597 4 21.6755 36.9888 11.229 7.35556 -7.61462 10.605 +1598 4 22.8593 36.0261 11.4203 4.02803 -2.23458 -0.408194 +1599 6 50.7458 20.5312 30.3336 -27.3371 19.0798 0.575242 +1600 4 50.2829 20.0188 31.024 4.3389 0.549123 -5.17754 +1601 4 50.1148 21.2814 30.1453 20.3707 -20.1638 4.65154 +1602 6 20.8352 3.85006 18.1924 -4.58005 6.82859 16.651 +1603 4 21.6331 4.17131 17.7775 4.55578 1.29171 -4.07778 +1604 4 20.7516 4.34878 19.0287 -0.852135 -6.30171 -7.97465 +1605 6 4.00732 20.6422 6.98905 -51.5603 -31.2986 19.6291 +1606 4 3.1116 20.4695 6.56725 35.2765 12.481 -1.34365 +1607 4 3.83148 20.2497 7.8921 17.5771 16.9916 -21.2359 +1608 6 11.9503 15.4361 41.4392 2.8915 -19.3712 8.63656 +1609 4 11.9967 14.4718 41.7234 3.98465 29.7679 -14.4511 +1610 4 12.4631 15.5787 40.6176 -3.08486 -9.43894 7.49139 +1611 6 3.00006 18.5443 38.9307 7.29951 -23.84 25.6029 +1612 4 3.57591 17.7463 38.8471 -9.50595 12.5214 2.28144 +1613 4 2.93408 18.9335 38.0756 -3.85177 13.2219 -26.1975 +1614 6 8.60604 38.8696 11.3027 41.4164 30.2615 0.48057 +1615 4 9.41419 39.0226 10.7506 -16.8144 -5.25469 8.62565 +1616 4 8.21901 38.0768 10.9944 -17.9318 -38.1368 -15.4555 +1617 6 12.9777 33.9736 38.4849 13.2116 9.7409 3.49313 +1618 4 12.6169 33.1824 38.0476 12.8065 1.18326 0.516457 +1619 4 13.9558 34.0654 38.367 -20.6967 -9.66923 -0.235313 +1620 6 4.68265 11.9882 6.05233 -5.36104 -17.6375 -21.4001 +1621 4 3.82121 11.6194 5.80881 -7.3972 4.97776 10.103 +1622 4 5.22981 11.6659 5.30604 -0.806592 6.4598 12.5779 +1623 6 10.8388 15.9226 25.2234 -25.8257 0.885817 -3.68505 +1624 4 11.7194 16.2357 25.361 23.5714 9.8582 3.12124 +1625 4 10.3656 16.637 24.773 5.49819 -5.38784 0.449897 +1626 6 20.7519 3.25216 6.54608 14.2232 16.6176 4.63006 +1627 4 20.286 2.47445 6.25961 -10.3965 -11.4853 -2.16446 +1628 4 20.1859 4.03183 6.47283 -6.25253 -2.40724 -3.99784 +1629 6 47.6296 39.155 31.2075 -6.94169 16.2372 -29.2685 +1630 4 46.6717 39.1522 30.9686 19.778 5.05469 4.61154 +1631 4 48.0746 39.7923 30.5789 -18.3255 -25.0069 20.1215 +1632 6 8.32942 27.7692 27.6861 -22.9675 10.5768 13.2964 +1633 4 7.92083 27.0814 28.2574 8.55111 11.2092 -8.24047 +1634 4 9.05389 27.3382 27.2479 10.5137 -11.4359 -5.41666 +1635 6 33.26 40.3166 33.4176 17.9089 -0.14465 -4.13778 +1636 4 32.5337 40.9457 33.2593 10.2249 -4.59604 -5.86803 +1637 4 34.0027 40.4737 32.781 -17.2015 3.54767 8.86095 +1638 6 24.5063 34.6298 27.2698 0.491312 8.45089 -9.78892 +1639 4 24.8706 35.531 27.0561 -9.74802 -22.5685 0.190878 +1640 4 24.1 34.2837 26.4337 10.8101 11.1551 19.1745 +1641 6 13.3248 36.7606 35.7302 31.7841 1.54421 8.12469 +1642 4 14.2215 36.6075 36.119 -13.0291 10.9369 -8.07597 +1643 4 12.8242 36.0333 36.0767 -19.6956 -11.898 1.78685 +1644 6 34.0654 20.1519 33.2169 18.328 45.6356 -7.38724 +1645 4 34.7846 20.5927 32.7056 -13.2567 -20.8909 7.62801 +1646 4 33.6055 20.9496 33.5712 -4.62613 -21.3045 2.82084 +1647 6 22.8301 33.56 31.6141 4.86266 11.3389 -12.2002 +1648 4 23.5774 34.1707 31.5466 -2.83601 4.36281 -5.03091 +1649 4 23.1188 32.9172 32.2538 0.234413 -13.6868 11.6365 +1650 6 23.7437 2.42751 19.8437 5.37542 22.288 12.015 +1651 4 24.549 1.92657 19.7151 11.8542 -9.34304 -3.08207 +1652 4 23.0522 1.96699 19.3939 -17.1839 -15.7883 -12.7178 +1653 6 10.5922 1.64055 20.5239 -11.6119 -4.18685 -4.47424 +1654 4 10.0475 0.976152 20.0603 6.63037 0.339841 6.84259 +1655 4 10.5 2.45781 20.009 1.22375 1.55874 1.33627 +1656 6 6.49834 24.8637 7.80908 13.1619 -16.462 -27.2261 +1657 4 7.39752 24.8711 7.42138 -7.39511 8.18905 12.026 +1658 4 6.07255 24.1767 7.26903 -7.5733 6.7583 6.8074 +1659 6 54.7892 32.5297 25.4757 -1.36407 18.5665 -18.8778 +1660 4 54.0312 33.1434 25.3693 10.0694 -13.7478 6.1371 +1661 4 0.333918 32.6202 24.6425 -12.8409 -6.42816 22.883 +1662 6 6.2467 20.1884 28.9797 -14.5872 3.94595 -2.55046 +1663 4 5.42154 20.1642 28.4577 8.07739 1.90281 8.6477 +1664 4 6.84484 19.6236 28.4838 10.3646 -4.74821 0.341067 +1665 6 50.0565 21.6117 11.3373 -2.04109 28.5423 -29.4123 +1666 4 50.95 21.7264 10.9878 2.40449 3.31798 -5.14809 +1667 4 50.1463 20.9073 11.9368 0.900865 -33.3483 27.1981 +1668 6 43.4794 33.5181 19.6392 10.2306 -3.22473 -8.26676 +1669 4 43.7308 33.5714 20.5426 20.9097 -0.172793 18.6354 +1670 4 42.5556 33.6283 19.7345 -31.1875 3.87355 -8.92325 +1671 6 30.8203 7.18413 41.0653 -47.5647 29.7584 13.5959 +1672 4 29.9879 7.63165 40.681 33.629 -21.8567 10.9994 +1673 4 30.7637 7.50249 0.10761 7.36747 -14.0232 -31.1296 +1674 6 12.1328 25.8622 11.0863 -33.3162 -17.1307 -4.35232 +1675 4 11.2035 26.0164 10.7385 31.652 5.74526 10.6132 +1676 4 12.7063 26.6022 10.9281 7.22016 21.1466 -6.88425 +1677 6 47.8272 5.81934 17.7377 34.4122 -10.5063 -19.6374 +1678 4 48.0885 5.28838 16.9377 -7.84164 17.03 17.5567 +1679 4 48.6906 6.1712 18.0872 -20.5621 -5.0871 -4.09565 +1680 6 35.1646 12.9005 16.5891 -8.94037 2.15609 -8.82704 +1681 4 35.428 13.0005 17.5199 -6.39768 8.78744 -5.13392 +1682 4 34.5308 13.6301 16.3523 17.2323 -15.7422 12.9621 +1683 6 10.4611 10.6156 33.9687 -31.8989 -9.58391 14.7288 +1684 4 10.7981 11.3375 34.5166 5.24051 -2.75865 -7.26377 +1685 4 9.62118 10.4004 34.4306 17.5569 -1.50819 -12.473 +1686 6 9.86916 7.4616 9.67483 -1.17411 0.415312 -19.5192 +1687 4 9.17172 8.12646 9.7346 0.921409 2.8109 10.1471 +1688 4 9.97058 7.3459 8.70248 1.1017 -0.154201 19.4763 +1689 6 11.1489 9.5612 29.1408 -3.50418 -13.4139 2.93109 +1690 4 10.6848 9.26325 29.9428 4.68224 5.10434 -5.79998 +1691 4 11.3989 8.73954 28.6776 0.998479 5.88331 1.3781 +1692 6 46.4028 12.7539 37.8993 8.34964 0.221 -8.93676 +1693 4 46.6625 12.9969 36.9769 -3.46511 -1.57209 17.4302 +1694 4 46.8246 13.3669 38.5286 -1.63466 -3.53539 -5.22058 +1695 6 4.76485 19.028 16.0085 -13.5875 12.8334 -9.71245 +1696 4 4.2246 19.0797 16.8211 14.4547 -7.44532 -2.23877 +1697 4 5.5965 18.5831 16.2078 1.83868 -2.3176 10.3072 +1698 6 50.2593 39.8135 19.3633 -11.209 7.32279 -16.1387 +1699 4 50.2357 39.0929 20.0186 -9.83071 -0.813057 -10.1916 +1700 4 49.5811 39.7404 18.6324 20.3589 -6.83946 23.6454 +1701 6 3.57863 23.2976 26.309 -19.8478 3.89203 -2.42552 +1702 4 2.95325 23.1663 25.5593 11.1236 -1.69658 12.5574 +1703 4 3.09228 23.9147 26.9028 8.7219 -10.8877 -9.85517 +1704 6 43.325 18.2347 20.509 -6.81505 -1.42332 -3.46621 +1705 4 42.8171 19.0284 20.7204 1.20306 1.51529 1.23812 +1706 4 43.8577 18.0426 21.2915 2.12676 -2.58083 4.4502 +1707 6 14.5031 41.5275 19.7277 -3.40329 -5.13047 -40.8094 +1708 4 13.9246 41.7804 20.437 0.184992 5.83632 25.1113 +1709 4 15.42 41.4218 19.9774 10.3149 -1.62678 14.571 +1710 6 29.2836 29.8681 26.9083 14.7251 3.00272 -32.0725 +1711 4 29.2754 29.741 25.8744 6.18055 14.2787 56.2455 +1712 4 30.1283 30.2623 27.2985 -22.384 -15.5718 -22.4063 +1713 6 6.3217 26.153 11.5726 -10.9318 2.11689 -6.65038 +1714 4 6.21736 25.7454 12.4421 7.16784 6.77942 9.71283 +1715 4 6.96084 26.8819 11.5675 -0.124344 -5.20772 8.78036 +1716 6 27.6636 9.22988 15.2432 27.2347 15.0341 -6.49447 +1717 4 28.4103 9.83484 14.9873 -20.1055 -14.3916 8.85848 +1718 4 27.7674 8.48088 14.6445 -1.45999 -3.40178 1.02673 +1719 6 29.7804 38.0662 17.0819 -1.94795 -3.59677 -9.66723 +1720 4 29.6031 37.2203 16.6025 -2.55573 18.1678 4.54076 +1721 4 29.1155 38.7497 16.8561 3.55432 -16.3657 1.57327 +1722 6 52.2257 28.7184 4.26028 43.5541 11.735 -13.9492 +1723 4 53.1498 28.7813 3.86382 -28.9168 1.3453 15.0129 +1724 4 51.9642 27.8111 4.13511 -4.98861 -18.1961 -3.0857 +1725 6 17.1716 16.6708 6.09349 0.800403 22.8617 11.3476 +1726 4 16.9906 17.4665 6.64994 5.32834 -8.85643 -15.9231 +1727 4 16.9912 15.9587 6.69883 -0.0606397 -19.1034 5.18453 +1728 6 36.6551 7.54529 33.4256 0.520164 -21.8515 26.6937 +1729 4 35.9994 7.02185 33.9501 8.71508 10.7979 -12.9224 +1730 4 36.139 7.85703 32.6949 -12.9525 8.58568 -17.7829 +1731 6 26.1712 3.13186 9.59195 18.1066 21.2961 -28.5304 +1732 4 26.5502 3.5196 10.357 16.0028 12.4994 23.003 +1733 4 25.6506 2.45477 9.93435 -32.3265 -38.1289 14.2303 +1734 6 1.19956 17.1196 33.1708 -2.2935 18.3305 -9.07621 +1735 4 1.01553 17.8006 32.4822 1.56489 -10.8534 12.1427 +1736 4 0.844206 17.4429 34.0214 2.04572 -1.59411 -6.06332 +1737 6 29.1739 10.178 5.37516 -2.40587 -18.3881 11.7134 +1738 4 28.5386 10.354 6.08377 0.376669 4.93981 -3.98875 +1739 4 29.4881 9.26834 5.54278 -5.29161 7.67482 -7.40705 +1740 6 9.22817 21.1342 0.188585 30.2393 3.90367 9.01386 +1741 4 10.0008 20.6689 41.6954 -19.6386 2.89796 1.05729 +1742 4 8.40981 20.8027 41.7407 -2.68979 -7.66638 -7.21336 +1743 6 7.42006 26.8879 34.8536 3.14545 16.5486 30.4349 +1744 4 7.04622 27.0927 35.7464 10.1233 -6.04195 -26.4158 +1745 4 6.87255 26.19 34.5186 -13.4343 -18.5802 -10.0193 +1746 6 18.6153 10.1647 3.02259 -21.2705 37.3854 6.86975 +1747 4 17.9982 9.42011 2.89287 2.11135 15.8633 3.52195 +1748 4 18.115 11.0437 3.25865 19.508 -44.5053 -11.6159 +1749 6 13.1266 21.2208 25.207 -7.78894 4.80204 -7.88194 +1750 4 12.927 21.6586 24.3646 3.95449 -7.72121 4.87382 +1751 4 12.8054 20.3208 25.1571 -2.69895 -8.80511 -3.48609 +1752 6 4.90585 24.4116 40.531 -24.4864 -14.2944 -35.1794 +1753 4 5.64285 24.6041 41.0938 21.6142 3.21823 7.1591 +1754 4 5.22115 23.997 39.6806 -3.1008 12.4445 27.1665 +1755 6 54.7234 6.29054 9.93868 16.9838 3.76988 -11.4262 +1756 4 54.1595 6.0167 10.6465 -16.0707 -8.53288 16.3243 +1757 4 -0.00708757 7.17696 10.1972 2.88265 8.42125 0.296955 +1758 6 51.7481 16.6603 19.3703 -0.380283 5.87397 -29.4424 +1759 4 51.6376 16.2748 18.4816 -6.94363 -1.60509 11.109 +1760 4 52.3909 17.3585 19.2003 6.35466 6.30558 5.78841 +1761 6 38.6244 2.9738 13.1093 11.8256 2.30897 44.7329 +1762 4 38.5518 3.44318 13.9917 -0.399232 -9.9856 -23.4333 +1763 4 38.2423 3.54447 12.4592 -11.1085 17.5319 -17.0773 +1764 6 19.4422 35.7095 9.59568 3.40577 -0.828385 -4.73593 +1765 4 18.7414 36.105 9.07989 -9.16576 -3.00828 -7.06541 +1766 4 19.0009 35.4265 10.4088 3.97598 4.46758 -4.25365 +1767 6 46.943 37.6271 25.6985 10.3793 1.77648 -5.56802 +1768 4 47.12 37.9785 24.823 -9.34628 8.6078 -10.4475 +1769 4 47.7536 37.1497 25.8683 2.27046 -5.59472 9.98269 +1770 6 20.0359 17.269 14.7493 3.99527 -1.04076 21.685 +1771 4 19.226 17.5112 15.2169 -1.54973 1.23777 -13.9596 +1772 4 20.6203 17.0021 15.471 1.89523 -0.789097 -10.2839 +1773 6 24.7462 29.2867 3.75843 -10.1451 -8.18783 10.4774 +1774 4 24.6712 28.3277 3.51733 13.2212 23.8029 -9.5704 +1775 4 25.3186 29.8222 3.19111 0.258423 -15.3949 -10.1904 +1776 6 3.43 8.91865 6.82525 30.9316 4.78471 42.1024 +1777 4 3.12906 8.84201 7.76799 3.51474 0.65101 -30.0512 +1778 4 4.4001 9.15772 6.93718 -35.8795 -6.21414 -10.2854 +1779 6 17.4867 30.5875 19.7089 25.363 -13.1809 -11.8275 +1780 4 18.4189 30.3609 19.3993 -33.7851 8.31766 10.936 +1781 4 16.9116 29.8624 19.4038 1.038 7.7974 -2.73085 +1782 6 13.2718 16.1862 39.0546 8.76191 -18.4723 6.03369 +1783 4 13.8233 16.8904 39.4031 3.30361 7.54485 1.72389 +1784 4 12.5422 16.5765 38.5789 -11.7633 13.4881 -8.40344 +1785 6 23.832 27.9756 11.5898 -7.03122 5.38421 -2.05105 +1786 4 23.0756 27.4469 11.9259 8.81977 12.3317 -3.01362 +1787 4 23.7182 28.9056 11.8688 -5.28793 -12.9553 -0.41204 +1788 6 14.4579 24.426 21.2343 -3.66896 12.863 -1.79834 +1789 4 13.9584 25.2806 21.2855 7.33453 -15.5065 2.73981 +1790 4 14.2661 23.9117 22.0367 -3.91682 9.90798 -0.991428 +1791 6 46.6073 15.1543 22.2965 -20.8333 -3.77381 -11.8272 +1792 4 45.9584 14.6421 21.811 -6.87655 -3.95362 10.1018 +1793 4 47.2458 15.2644 21.6001 24.1162 10.8017 0.759212 +1794 6 19.1409 29.7195 11.8497 24.0494 -34.2428 10.0272 +1795 4 18.8784 30.5975 11.5793 -19.1418 4.86007 -17.3781 +1796 4 18.6106 28.9994 11.4276 0.263541 23.8948 1.0376 +1797 6 36.9127 18.8084 27.6222 -22.9356 -21.6011 26.171 +1798 4 36.4352 18.471 26.8408 6.36827 4.7914 5.64024 +1799 4 36.536 18.2194 28.3533 14.6987 24.2872 -28.1415 +1800 6 35.8684 17.5378 25.4906 20.6945 -0.513689 -30.4481 +1801 4 36.5966 17.7728 24.866 -15.8574 8.27186 11.6809 +1802 4 35.9779 16.5759 25.48 -10.902 2.42848 10.2606 +1803 6 8.03691 41.9141 31.5248 13.0394 10.4535 -6.8036 +1804 4 8.57921 41.2412 31.9888 -13.1962 14.522 -11.1095 +1805 4 8.63283 0.684743 31.1326 -8.3799 -15.4286 7.32752 +1806 6 31.7059 34.8342 17.9371 1.99631 -25.0047 -8.79133 +1807 4 32.5911 34.4609 17.7211 -13.4776 12.334 6.09844 +1808 4 31.8527 35.7258 18.2497 13.1847 15.6537 3.27409 +1809 6 22.1093 41.055 5.1451 11.5479 29.9587 -53.8497 +1810 4 22.1004 40.5969 5.93279 -2.68624 -33.8843 55.363 +1811 4 22.7885 40.6204 4.60559 -4.38419 0.844423 3.37931 +1812 6 11.6153 5.16618 29.5584 -27.6475 13.1782 12.6346 +1813 4 12.1606 4.37097 29.6057 -8.91967 -2.9702 4.15115 +1814 4 10.7377 5.1092 30.0631 35.581 -10.2726 -16.0904 +1815 6 13.0239 9.45481 21.0754 -25.8377 -26.1508 -25.9824 +1816 4 13.6778 9.97234 21.4999 31.652 16.6928 15.5055 +1817 4 13.4195 8.72209 20.5617 -0.589626 12.3395 6.44381 +1818 6 12.4227 4.1736 0.163828 29.6522 45.8695 -12.8421 +1819 4 12.6651 3.77524 1.00427 0.341759 -1.42745 2.51987 +1820 4 13.0617 4.97102 0.020112 -31.9214 -41.0145 4.8633 +1821 6 45.168 14.6284 28.1023 4.783 -10.4532 13.0266 +1822 4 45.253 14.8969 27.1759 8.39119 -6.85383 -0.732919 +1823 4 45.9575 14.0916 28.3529 -13.3622 13.2892 -14.7888 +1824 6 52.571 19.2551 0.894665 -6.12931 -19.318 2.27414 +1825 4 52.6102 19.199 41.8388 0.592413 0.00811024 1.08479 +1826 4 52.8129 20.1442 1.11528 6.55776 18.4237 2.43046 +1827 6 0.161625 18.5694 30.5785 -3.0227 0.535636 4.36465 +1828 4 0.968981 18.7291 30.0798 6.18464 -7.16445 -2.53371 +1829 4 54.7907 19.4514 30.677 -10.8229 5.89199 6.00525 +1830 6 17.6528 28.1849 1.96402 -7.28907 9.7522 11.2687 +1831 4 16.9769 28.8628 1.74785 9.23997 -9.27082 -2.31394 +1832 4 17.6006 28.1534 2.93661 3.56557 1.38454 -8.44201 +1833 6 22.5099 30.1653 5.01109 -1.02808 20.8676 -0.473944 +1834 4 23.1753 30.1014 4.30975 -2.49536 -9.56192 4.09657 +1835 4 22.058 29.3206 5.04766 -1.45363 -6.71999 -4.50103 +1836 6 11.4023 8.80853 17.6459 -26.9993 9.53928 -4.75555 +1837 4 11.8645 8.1762 18.2108 15.3222 4.18532 1.52515 +1838 4 11.9865 9.48216 17.2519 4.47877 -12.4161 10.2871 +1839 6 32.2917 3.59674 26.8117 35.3382 32.7507 -4.14644 +1840 4 31.8458 3.34967 26.0065 -10.4154 -4.5889 -14.8452 +1841 4 32.8806 4.37505 26.5671 -21.1848 -26.3524 0.379863 +1842 6 26.835 37.1568 15.6529 -0.874066 14.8773 29.2405 +1843 4 26.7488 37.4766 16.567 0.376185 8.65421 -15.6923 +1844 4 26.6891 36.2303 15.7909 -0.851881 -23.4278 -14.9094 +1845 6 22.9473 3.40289 22.286 14.7574 -3.5158 -4.23343 +1846 4 23.2792 2.98888 21.4515 -4.53852 7.92848 16.4552 +1847 4 23.7307 3.68139 22.8048 -11.9145 -5.32443 -10.4265 +1848 6 14.6269 28.2214 5.19572 6.06687 6.51489 2.87291 +1849 4 14.1454 28.1555 4.36712 -3.39073 -3.27129 -8.45242 +1850 4 14.2747 28.9991 5.64824 0.61258 -1.12864 1.62503 +1851 6 20.2538 37.2031 16.5466 -28.2562 5.81675 18.2866 +1852 4 21.1004 37.4666 16.2032 21.0823 8.59207 -3.85991 +1853 4 20.0754 37.7549 17.3418 4.82626 -5.93036 -10.2325 +1854 6 17.9544 28.5616 23.889 16.4449 -8.57642 -4.83649 +1855 4 18.808 28.1928 23.5683 -20.3084 2.86715 8.85187 +1856 4 17.2559 27.9215 23.6535 6.51898 5.694 -2.26134 +1857 6 33.646 24.2349 25.2286 -4.54069 1.10679 -14.8717 +1858 4 33.6591 23.269 25.0602 3.54988 10.512 10.2941 +1859 4 34.0237 24.3938 26.1034 0.864522 -9.38336 -2.59148 +1860 6 9.98122 17.6138 2.21344 7.43797 -27.5786 -7.49496 +1861 4 10.832 17.5317 1.73219 -10.6429 3.93943 7.97636 +1862 4 9.86311 16.7639 2.69719 0.409905 15.8492 -4.6087 +1863 6 24.3357 36.801 8.92185 2.98992 -6.60779 12.1866 +1864 4 24.0742 37.6409 8.56425 -5.30422 15.3919 -5.44039 +1865 4 24.7315 37 9.77917 -2.43549 -6.6012 -3.30269 +1866 6 14.4004 4.29557 27.7519 47.583 -3.32523 5.14754 +1867 4 15.335 4.40276 27.3948 -30.4143 -4.44284 13.8265 +1868 4 13.81 4.42145 27.0177 -13.2435 3.17509 -11.8406 +1869 6 13.214 25.4576 35.3169 -22.1271 -24.6319 4.29258 +1870 4 13.1587 25.1592 36.2444 11.1778 9.47444 -6.90086 +1871 4 12.4637 24.9943 34.8985 11.1514 12.2923 -1.08233 +1872 6 43.7301 33.1781 24.4042 -1.93578 -20.5981 16.0744 +1873 4 44.3223 32.959 25.1725 -10.0543 8.3706 -19.7015 +1874 4 44.0713 33.9344 23.9169 6.22405 5.02536 3.22562 +1875 6 6.9686 30.4099 7.14637 29.0056 7.39031 21.9321 +1876 4 6.75777 29.9621 7.98042 -5.17066 0.417247 -5.37485 +1877 4 6.23168 30.2842 6.57126 -23.4728 -6.8193 -11.7975 +1878 6 44.4308 39.4237 21.7855 -4.33275 0.914597 7.54549 +1879 4 43.8654 38.932 21.1541 10.179 9.64354 2.62582 +1880 4 45.001 40.0603 21.3196 -6.51882 -12.4268 -7.79327 +1881 6 1.18424 16.4398 24.9903 -32.4903 25.5998 2.59769 +1882 4 0.976951 16.9992 24.2076 17.4753 -17.2203 8.72915 +1883 4 0.385168 16.6115 25.5394 23.4019 -14.126 -4.16352 +1884 6 8.17355 33.8284 10.6836 -2.7688 -6.92624 14.1509 +1885 4 8.34263 33.4451 9.83813 20.7133 -1.8248 -25.0865 +1886 4 7.32622 33.4212 10.8229 -22.0824 -0.650197 20.9959 +1887 6 45.3734 15.866 40.492 8.57481 -12.1553 -4.93844 +1888 4 44.519 15.6937 40.0698 -0.240559 4.546 7.41406 +1889 4 45.2892 16.6061 41.0987 -5.95018 0.957053 0.609678 +1890 6 38.79 4.28815 15.8976 0.37918 -2.10791 -10.8791 +1891 4 39.6838 3.98516 16.099 -1.14178 2.00828 6.51653 +1892 4 38.4576 4.71748 16.7012 5.69678 -4.45181 -3.36891 +1893 6 21.0946 9.20757 23.9781 -15.5567 7.8487 -28.256 +1894 4 20.9171 8.74785 23.1381 12.0597 -4.77706 12.6228 +1895 4 20.522 9.98378 23.8483 8.03519 -2.74416 16.612 +1896 6 6.47513 36.1489 20.0112 1.62078 -0.443995 1.26518 +1897 4 5.91587 35.3892 19.7749 1.1588 6.62155 -0.72477 +1898 4 7.29927 35.7814 20.3561 -3.99682 -1.77997 -1.59627 +1899 6 17.7466 23.4563 11.2529 28.5847 -29.2717 26.027 +1900 4 17.0283 23.9723 10.9251 -27.3158 17.875 -1.49359 +1901 4 17.6201 23.2782 12.2162 -8.22502 9.28058 -23.7318 +1902 6 2.23619 39.2644 23.5388 49.8561 -28.1857 -22.6679 +1903 4 2.97831 38.9599 24.1359 -27.9038 8.524 -11.8523 +1904 4 2.61824 39.0932 22.6246 -22.7997 11.7085 33.9524 +1905 6 21.7216 10.3211 3.08421 -18.2449 14.4951 30.0936 +1906 4 21.8041 10.0076 2.215 15.0715 -18.3252 -42.7176 +1907 4 20.7597 10.3501 3.18369 2.1836 1.89441 6.77029 +1908 6 13.3346 37.6456 26.8309 31.2085 -13.7023 -2.95714 +1909 4 12.8405 36.9633 27.2803 -9.16641 -7.21061 8.74396 +1910 4 14.167 37.1703 26.5501 -23.1686 18.0804 4.61389 +1911 6 45.6739 9.85296 8.82966 10.4005 6.57186 1.33947 +1912 4 45.3411 9.70411 7.93855 -5.0879 -2.60549 -0.62074 +1913 4 45.1871 9.30295 9.44221 -8.90854 -6.98805 -1.17873 +1914 6 39.813 32.3454 29.581 6.89703 -12.1014 5.95535 +1915 4 39.6485 31.4219 29.3549 -7.08038 -1.01192 -10.7476 +1916 4 40.3223 32.2375 30.3827 0.600223 8.34958 5.32896 +1917 6 39.1399 32.1558 8.97291 22.8595 -6.45003 -40.3239 +1918 4 39.6086 32.0592 8.09926 -10.5081 2.64219 35.3633 +1919 4 38.2198 32.2158 8.71089 -7.955 1.72328 8.07951 +1920 6 29.7568 11.3071 40.3305 36.1908 -28.2332 -10.1569 +1921 4 29.0987 10.6276 40.5022 -6.8613 -0.261357 1.73371 +1922 4 30.5966 10.7518 40.2867 -25.0211 23.0598 -1.19829 +1923 6 24.8367 19.8778 29.8512 -3.76004 22.8831 22.3698 +1924 4 24.8428 19.0032 30.2276 -1.20959 -17.1847 2.11456 +1925 4 24.5914 20.4528 30.618 6.24059 -13.3215 -18.0816 +1926 6 50.0702 29.4819 2.87168 7.70946 6.50978 -10.1722 +1927 4 50.8345 29.4231 3.46787 -5.92296 0.441099 -8.02421 +1928 4 50.4135 29.3271 1.96617 -11.3825 0.248157 19.2026 +1929 6 26.3309 13.2577 37.9673 -13.8105 -3.9786 -34.6653 +1930 4 27.2227 13.0528 37.6163 -4.21147 3.58808 27.148 +1931 4 26.2568 13.475 38.8976 18.37 3.27206 13.6317 +1932 6 24.3356 13.8068 16.1475 3.59325 -0.347239 -0.208698 +1933 4 24.7367 14.1162 16.9522 4.68271 -6.41054 14.6744 +1934 4 24.1923 14.631 15.6832 -6.43367 3.48529 -13.6665 +1935 6 21.9593 25.0956 8.01078 27.9223 3.76027 7.52529 +1936 4 22.6404 25.6041 7.51239 -14.7718 -5.75747 5.32796 +1937 4 22.4795 24.6555 8.71494 -11.0917 7.59151 -10.9937 +1938 6 50.1732 25.2931 29.034 -22.8769 -27.0861 -14.4889 +1939 4 50.9231 25.1249 28.4453 9.52927 7.92169 5.9345 +1940 4 50.3853 25.9631 29.6741 16.3661 14.9722 8.20298 +1941 6 23.1854 6.82331 7.6223 5.22953 23.7057 -4.54178 +1942 4 23.9785 7.3899 7.84298 -26.8007 -12.7469 -6.01791 +1943 4 22.4118 7.42329 7.468 18.2581 -13.076 4.30509 +1944 6 6.92213 5.8571 20.8332 2.72627 6.95854 -11.5419 +1945 4 7.54915 6.58218 20.6217 -11.8273 -13.0803 1.39721 +1946 4 6.56012 5.53917 19.9848 5.57208 -2.46181 7.62025 +1947 6 25.395 39.7583 23.949 6.36773 8.3837 -46.9746 +1948 4 25.6324 38.8356 24.0083 0.522678 -6.92882 12.1803 +1949 4 25.626 39.9451 22.9935 -8.38215 2.07882 31.2615 +1950 6 10.8464 30.695 2.12273 2.92699 -11.4721 29.0623 +1951 4 9.93667 30.8598 2.41274 2.41412 3.42254 -4.79395 +1952 4 11.0072 31.0743 1.26994 -5.60296 10.8359 -22.248 +1953 6 23.0784 40.5299 40.0517 -12.8303 7.3127 -19.6888 +1954 4 23.7801 40.7079 39.3995 -2.98216 -3.06267 5.67195 +1955 4 22.2752 40.9489 39.6621 13.0026 -6.04267 8.58422 +1956 6 29.2116 28.3822 37.564 -38.7174 33.0362 -17.1388 +1957 4 28.2182 28.3913 37.3962 39.4392 -4.09178 7.25715 +1958 4 29.4217 27.5495 37.9564 8.20519 -19.4736 9.10227 +1959 6 1.867 12.1738 18.0852 -6.50713 5.08339 -35.4355 +1960 4 2.57398 11.838 18.6163 6.10024 -5.16113 22.8519 +1961 4 1.13063 12.5086 18.5994 -2.48645 -2.83143 13.3981 +1962 6 35.8305 14.0949 8.56039 26.0881 18.3061 13.156 +1963 4 35.1714 13.4739 8.88749 -16.8661 -4.96187 -13.4504 +1964 4 35.7684 14.4109 7.636 -16.9096 -16.2229 2.78164 +1965 6 9.49198 39.8165 37.5846 25.5398 -19.6342 8.10058 +1966 4 10.4488 39.5668 37.3792 -35.3087 19.1509 -1.98674 +1967 4 9.11285 40.4907 37.0027 15.1686 -3.88151 -5.41116 +1968 6 3.54864 30.3444 19.2746 19.2588 -4.84534 25.5649 +1969 4 4.39288 30.8221 19.2218 -5.35887 2.33403 -8.35831 +1970 4 3.69938 29.8 20.0823 -8.98886 6.07327 -15.723 +1971 6 36.3172 32.3761 17.5568 -52.716 -14.5505 -10.7859 +1972 4 37.1181 32.7413 17.8285 45.3049 23.5946 19.1732 +1973 4 36.5447 31.7674 16.8589 0.0557097 -8.91784 -8.34906 +1974 6 22.0674 24.5243 41.4066 13.5104 10.4808 14.5301 +1975 4 21.9193 25.2614 0.114872 1.55544 -1.48024 -5.36737 +1976 4 21.3782 24.5469 40.7428 -11.5581 2.78113 -8.36201 +1977 6 45.7659 15.6016 11.6394 9.02046 4.78635 -7.96304 +1978 4 46.6299 16.0103 11.8091 -2.50167 -1.58301 0.968075 +1979 4 45.9087 14.6499 11.5698 3.7439 -8.72722 -0.994242 +1980 6 22.3679 20.3809 16.0361 -10.6504 -17.4294 -19.3744 +1981 4 21.763 20.3139 16.7773 -4.42579 5.53693 13.3566 +1982 4 23.0073 21.0579 16.2253 11.6801 17.1208 13.2616 +1983 6 25.8325 25.7487 18.9031 6.26908 13.5994 -10.9759 +1984 4 25.2398 26.4837 18.648 3.49723 -12.6326 6.8661 +1985 4 25.3435 25.2434 19.5576 -3.6765 -3.23145 -0.768961 +1986 6 35.3178 34.202 33.2905 -17.6504 -29.1706 1.13026 +1987 4 35.3983 35.1402 33.2641 1.24044 29.706 -1.15043 +1988 4 34.4344 34.0427 33.6774 7.05439 -0.467604 -1.03347 +1989 6 39.2901 17.1075 17.3833 -11.3112 -26.2042 -1.68945 +1990 4 39.9794 17.7123 17.5836 17.425 19.0869 4.79839 +1991 4 38.575 17.6263 16.9966 -1.50153 2.1098 -0.940241 +1992 6 0.398412 14.9432 21.7856 9.03058 1.70326 -1.90296 +1993 4 54.4474 14.9193 21.5731 -3.898 -0.019948 -1.7993 +1994 4 0.528431 14.174 22.3634 -0.170355 0.861544 -0.399335 +1995 6 15.987 23.2263 17.7743 4.36624 14.6934 -7.14303 +1996 4 15.4857 22.9799 16.9684 3.82047 1.22984 7.38673 +1997 4 16.1722 24.1939 17.7179 -4.44652 -15.4901 1.96988 +1998 6 5.24865 11.1141 17.5618 6.95422 37.8037 -9.42255 +1999 4 4.73778 10.3127 17.5906 4.69561 -15.2682 10.3552 +2000 4 6.07662 11.1201 18.0866 -14.6292 -19.4463 0.240297 +2001 6 9.34435 36.7122 13.2675 14.3848 -20.4853 -8.45434 +2002 4 9.62142 35.7704 13.1913 -3.31983 12.7393 -0.467066 +2003 4 9.65952 37.1602 12.4706 -4.49166 -2.86228 3.29419 +2004 6 25.4918 33.5767 0.585194 -13.2513 47.819 -13.0434 +2005 4 25.5067 34.5261 0.924259 2.87868 -31.0124 -5.96193 +2006 4 25.9276 33.0244 1.21144 10.5779 -12.847 23.4116 +2007 6 17.3034 24.3894 31.3332 -3.83374 11.0726 -5.16798 +2008 4 17.6693 25.1812 30.9068 -1.9735 -3.85303 -0.254684 +2009 4 16.6127 24.6926 31.9382 -2.66612 -1.73239 2.61398 +2010 6 50.552 32.7161 27.7939 3.69414 -2.86079 -12.6149 +2011 4 50.6897 33.0491 28.6758 -0.144502 8.45372 13.0825 +2012 4 49.6264 32.8868 27.6344 -12.0524 -1.73095 -4.05681 +2013 6 2.253 37.2274 16.11 8.45807 0.136394 4.49883 +2014 4 3.21927 37.2459 16.107 -3.10104 -5.97474 -11.5471 +2015 4 2.06307 37.5747 16.9848 -8.61924 1.9026 3.91491 +2016 6 25.7683 33.176 8.40354 -18.9203 -11.3347 4.07551 +2017 4 24.8717 33.1921 8.8134 13.9609 -2.48357 -8.81655 +2018 4 25.7602 32.4226 7.7918 -3.67744 3.53954 1.65329 +2019 6 24.768 7.83219 25.4219 17.632 21.1734 16.2998 +2020 4 25.4945 8.36147 25.0103 -20.1597 -14.0103 5.71998 +2021 4 24.2535 7.44908 24.728 -12.2137 -5.73332 -20.4071 +2022 6 44.006 27.3325 21.546 30.1554 -7.9652 -11.3918 +2023 4 43.2457 27.8583 21.7575 -19.7371 1.57643 -2.46296 +2024 4 43.7964 26.4976 21.0884 -11.5694 12.3441 5.98804 +2025 6 20.8391 32.0716 6.72617 12.9902 -8.35788 -26.5741 +2026 4 21.6065 31.456 6.61879 -16.2643 13.1482 10.0653 +2027 4 20.6646 32.3142 7.64123 9.40483 -3.67012 8.54308 +2028 6 0.615177 26.1024 3.99379 -2.52029 5.686 8.70358 +2029 4 0.872898 25.4419 3.3518 0.34785 -8.86692 -8.8337 +2030 4 1.24928 25.9906 4.70547 -1.00806 2.16518 1.82635 +2031 6 23.6932 0.22266 22.8575 19.6208 -9.09848 8.51526 +2032 4 23.2991 1.09802 22.9795 5.26519 -2.66393 -0.960482 +2033 4 24.6108 0.216177 23.2468 -26.6208 7.90328 -9.41734 +2034 6 35.6316 26.9489 6.47476 -11.9227 4.67096 -7.07616 +2035 4 36.2784 26.7656 7.18499 -0.847143 10.2035 -9.59556 +2036 4 35.6247 27.8854 6.12936 11.6979 -23.4314 22.5499 +2037 6 50.1669 7.09081 18.6924 -7.14542 -1.6973 -3.47771 +2038 4 50.8011 7.27946 17.9805 -1.08143 -0.293524 0.841141 +2039 4 49.7425 7.94753 18.8476 4.63932 0.367722 -3.05405 +2040 6 12.4741 14.8288 12.1922 -8.10271 -9.61402 10.4649 +2041 4 11.6958 14.4794 12.6802 13.1948 7.08912 -7.97814 +2042 4 12.1183 15.3251 11.4609 -4.91784 2.70917 -6.99785 +2043 6 52.4614 22.3688 36.3388 -11.0199 -17.3524 -23.0567 +2044 4 51.6251 21.9183 36.1306 -2.17212 11.6706 13.3338 +2045 4 52.9952 21.963 35.6316 8.38603 12.1418 11.4133 +2046 6 41.778 11.4842 39.1192 -2.94788 -8.5466 -71.3066 +2047 4 42.0712 11.6935 39.9642 18.9262 14.1801 48.2999 +2048 4 42.4688 11.7778 38.472 -13.5225 -5.5757 18.7019 +2049 6 13.7869 22.5139 39.1025 -32.0544 -7.10206 -10.9841 +2050 4 12.8164 22.2898 39.2995 40.1723 6.0649 -15.4789 +2051 4 14.0276 22.2847 38.1645 -11.932 2.241 24.8997 +2052 6 28.7471 19.519 21.8427 26.201 -31.4587 -3.42241 +2053 4 29.5077 18.8642 21.7553 -27.3151 19.4313 7.21597 +2054 4 28.709 19.939 20.977 -1.33904 3.86677 -3.41873 +2055 6 8.35104 21.6464 36.3873 -9.70021 11.1463 1.78198 +2056 4 8.59231 22.5715 36.3877 5.92817 6.74417 -5.91108 +2057 4 7.6521 21.6323 37.0621 1.10663 -7.27579 -5.05072 +2058 6 39.9466 23.9759 15.2079 21.5993 -7.98015 -41.1742 +2059 4 40.8727 23.6245 15.2724 -23.8836 11.1149 -0.884493 +2060 4 39.7538 23.9548 14.2182 -0.675121 3.14563 34.0025 +2061 6 8.14826 38.6974 22.5407 10.5164 -8.10765 28.5856 +2062 4 7.68497 39.3831 22.0542 -4.5186 11.15 0.90042 +2063 4 8.43687 39.0737 23.4204 -11.1896 -2.29822 -22.518 +2064 6 10.8609 20.1732 28.9608 12.8413 -0.923384 7.34695 +2065 4 10.0131 19.7426 29.0637 -5.9523 -4.47565 4.1188 +2066 4 10.8844 20.5008 28.0696 -0.703946 5.19258 -12.1525 +2067 6 36.9008 23.822 41.8156 -12.4363 21.7846 -10.0393 +2068 4 37.5711 23.2333 0.167128 40.9996 -19.7248 12.2972 +2069 4 36.1173 23.3131 41.9445 -23.6506 -5.40851 2.0223 +2070 6 23.7894 40.6868 33.3454 12.8596 -15.6087 -7.6142 +2071 4 23.0064 40.9655 33.8068 -12.9523 11.6172 4.83708 +2072 4 23.8763 39.7481 33.6232 3.5481 12.5289 -6.50269 +2073 6 4.67002 19.3025 35.4081 28.9654 -8.37802 15.8464 +2074 4 5.50304 19.0977 35.9037 -20.926 10.8248 -6.78781 +2075 4 4.54874 18.5079 34.879 -7.50763 -2.93955 -6.02594 +2076 6 9.44906 25.7726 10.897 4.32597 -4.58851 8.60165 +2077 4 9.18995 24.8319 10.8983 -5.5655 4.98255 -0.925486 +2078 4 8.69969 26.3126 10.6078 0.159443 -6.7376 0.514864 +2079 6 27.2776 22.4912 13.6121 -0.517147 -7.99313 -8.85992 +2080 4 27.155 21.7331 14.2088 0.0551372 2.14825 -2.63665 +2081 4 27.5226 22.1158 12.7439 -1.12325 6.52643 14.1544 +2082 6 41.0473 18.7721 23.2805 -1.65607 -7.19044 -7.91226 +2083 4 40.4257 18.2083 22.8124 7.09703 -3.21037 0.549063 +2084 4 40.4899 19.4448 23.6465 -2.2525 13.4867 10.2584 +2085 6 46.4847 28.3568 20.1596 21.4343 7.62243 20.4812 +2086 4 45.6558 28.0725 20.6313 23.6124 6.3397 2.68094 +2087 4 47.3103 28.4552 20.7557 -43.4876 -6.08109 -17.1535 +2088 6 14.856 15.3945 30.0569 12.1054 -1.48105 24.8406 +2089 4 14.6669 15.4041 29.1302 -8.67008 -4.83168 -20.7775 +2090 4 14.3859 14.629 30.4429 4.17574 5.50589 -6.96103 +2091 6 23.5299 24.7674 35.2089 8.01546 19.7663 24.3744 +2092 4 22.8065 25.3632 35.4756 2.8295 -9.26237 -7.23473 +2093 4 24.1647 24.8645 35.9517 -5.58112 -4.18239 -8.07128 +2094 6 19.8979 24.2128 28.4372 -8.55524 33.371 -10.5251 +2095 4 20.118 25.106 28.0235 -7.554 -30.7898 14.4583 +2096 4 18.9386 24.2465 28.5992 8.91169 -0.342387 -2.75065 +2097 6 45.9653 7.62821 20.2375 0.645938 -6.46631 40.9505 +2098 4 46.1455 7.81465 21.2011 -4.75538 -9.14986 -26.6761 +2099 4 46.2053 8.42523 19.7798 3.02803 13.7202 -10.1214 +2100 6 38.0274 12.476 8.2804 -12.7973 12.3245 -4.6187 +2101 4 37.3544 13.1993 8.5286 18.4233 -41.2645 -20.6098 +2102 4 37.689 11.8001 7.60922 -1.16355 31.2483 23.3325 +2103 6 46.9232 18.1908 8.45127 -20.6048 6.85227 14.7641 +2104 4 46.2435 17.4987 8.55233 4.56757 4.50302 -0.225601 +2105 4 47.4224 17.9381 7.68168 11.4282 -5.99968 -17.9171 +2106 6 10.854 13.9656 9.37577 10.6617 18.3473 -18.9154 +2107 4 10.3554 14.661 8.90618 -4.87744 -10.6328 11.7585 +2108 4 11.7492 14.0754 8.99486 -7.79483 -7.36366 10.4335 +2109 6 34.413 5.42618 14.0852 -12.6861 0.159125 26.6885 +2110 4 35.1199 5.9296 13.6715 10.4361 -4.78744 -13.6438 +2111 4 34.2786 4.53955 13.7091 11.464 2.02167 -7.62295 +2112 6 0.18261 0.234369 22.9555 2.77695 -16.1069 -0.480131 +2113 4 0.268342 41.6651 22.1144 -0.0234796 4.94264 7.55149 +2114 4 54.831 1.09037 22.7433 -8.12427 18.964 -5.90735 +2115 6 40.9343 30.5497 37.8912 -0.822728 -5.40818 -2.29365 +2116 4 40.0406 30.8803 38.1728 23.6728 -16.1598 5.2797 +2117 4 41.3254 29.8415 38.4693 -14.8835 20.0143 -6.13723 +2118 6 16.6534 17.3205 12.6874 14.7099 15.3782 -9.06546 +2119 4 16.1954 16.505 12.4572 -1.18797 -4.10455 -0.493236 +2120 4 17.006 17.6533 11.8352 -5.05849 -6.69802 12.8635 +2121 6 29.6898 5.4323 24.749 -0.0153423 -4.79708 -9.00604 +2122 4 30.3311 5.93507 24.2276 2.5605 1.293 3.45927 +2123 4 29.9547 5.54756 25.6733 0.859724 2.70473 -2.20341 +2124 6 49.8976 0.279 27.2063 11.3554 -10.6099 9.68168 +2125 4 49.8114 0.578981 26.2935 2.75523 0.634109 -3.06626 +2126 4 50.8097 41.8349 27.2847 -10.6363 5.42595 -5.44518 +2127 6 31.2372 31.739 15.2138 3.99594 22.7956 -4.27207 +2128 4 31.6256 30.8953 15.4507 4.79789 -4.71254 6.82751 +2129 4 31.9624 32.4004 15.1381 -14.4355 -14.737 3.33184 +2130 6 35.7805 24.1465 16.9504 11.9916 -3.59376 -8.04525 +2131 4 35.6914 24.9231 16.3572 2.28972 -11.6943 5.94213 +2132 4 36.6882 23.763 16.8157 -19.8391 7.30154 4.46135 +2133 6 24.2601 4.62781 36.7306 -2.73038 -12.1142 -21.0154 +2134 4 24.8177 5.17448 37.2794 5.25293 5.76293 7.44764 +2135 4 24.6802 4.67277 35.8537 -9.35577 -2.69704 9.81341 +2136 6 17.5719 12.8989 3.66466 27.7221 -13.8379 -12.2911 +2137 4 17.7111 13.5231 2.92461 -8.26776 -5.83385 13.2655 +2138 4 16.7968 13.1561 4.15408 -15.8703 8.33112 4.7305 +2139 6 4.16771 14.2922 18.2601 -1.91899 -29.1082 -10.1028 +2140 4 4.22837 13.3107 18.2109 4.90834 19.7408 -0.578384 +2141 4 3.27435 14.4381 18.5824 -9.9871 6.86755 4.44487 +2142 6 19.1699 36.8381 22.3902 -4.55286 10.0742 -5.97046 +2143 4 18.832 36.3461 23.1414 -4.92402 -9.67799 11.164 +2144 4 19.5712 36.1952 21.8056 6.33502 -12.5333 -3.55186 +2145 6 15.653 11.96 13.2084 19.351 18.6963 0.185202 +2146 4 15.6609 12.833 12.7547 -2.35489 -19.4305 9.56752 +2147 4 16.5767 11.8359 13.5469 -18.24 -1.16426 -6.81767 +2148 6 24.7461 21.9204 5.38797 -27.1503 3.38708 1.08719 +2149 4 25.0422 21.7466 6.29562 -9.42613 0.489783 0.293639 +2150 4 23.7615 21.7936 5.33342 31.5349 -1.60743 10.1723 +2151 6 52.731 18.5617 35.2291 -23.3227 -9.96089 -3.35821 +2152 4 52.3432 18.0885 34.4925 12.0283 -8.22578 -16.7439 +2153 4 51.9379 18.6142 35.7503 -4.18579 12.1235 24.3517 +2154 6 3.56339 27.2782 25.2861 -13.9068 -17.971 -11.9546 +2155 4 3.93933 27.1708 26.1554 6.48024 -2.07304 15.4908 +2156 4 3.97283 28.0403 24.8958 8.97188 17.1762 -5.24442 +2157 6 34.4703 32.9949 30.674 6.71734 26.132 41.1649 +2158 4 33.5303 32.9277 30.8218 -10.267 -13.4259 -20.1884 +2159 4 34.6757 33.5653 31.4552 13.6938 -14.1125 -21.2315 +2160 6 35.2703 23.7477 9.841 1.59588 4.98779 0.126485 +2161 4 34.557 23.9691 9.22977 0.987563 3.83206 0.754652 +2162 4 35.6213 22.923 9.5082 6.82753 -10.3388 -1.5208 +2163 6 42.4139 15.7114 8.97964 24.1102 0.334397 4.42901 +2164 4 41.6569 15.4185 8.4899 -23.1764 -3.9339 -8.15459 +2165 4 42.1019 15.9745 9.85446 -9.30455 -0.897043 1.06511 +2166 6 7.76859 28.8573 32.9442 -15.9037 16.0354 -10.4898 +2167 4 7.97908 28.1549 33.5519 6.36032 -10.9608 11.0673 +2168 4 8.54203 29.0732 32.4131 7.8922 -1.0693 -1.41065 +2169 6 17.6887 41.2397 36.4833 -13.2152 -10.2381 33.1554 +2170 4 16.9194 41.8027 36.6113 -2.7651 1.17246 3.809 +2171 4 17.9462 41.408 35.602 16.1966 5.46369 -29.7656 +2172 6 28.4973 24.2486 15.5471 -12.6583 -10.112 -30.4241 +2173 4 29.1017 24.9078 15.1992 6.65529 6.29726 4.69488 +2174 4 28.2904 23.7156 14.7389 1.39534 3.17619 21.4563 +2175 6 20.9519 16.2974 1.15248 44.1264 9.982 -6.69009 +2176 4 20.9895 15.4004 1.43432 -0.0798072 -22.9414 11.198 +2177 4 20.0538 16.5254 1.09156 -44.6028 7.62895 -2.50253 +2178 6 31.1717 40.7384 5.29995 -1.14335 -24.9234 -14.6262 +2179 4 30.3101 40.4535 4.98914 0.542473 -7.39845 -0.335603 +2180 4 31.0069 41.6267 5.54556 -2.10438 36.1837 12.2935 +2181 6 29.9172 24.7601 36.4536 2.52587 12.7881 -5.39704 +2182 4 30.4095 25.4459 35.9567 -7.35112 -4.48214 8.13095 +2183 4 30.0744 23.9625 35.9621 2.47343 -16.947 -5.4104 +2184 6 8.66853 31.0461 3.90506 3.77884 -22.5587 -9.29968 +2185 4 7.73756 30.8263 3.92016 -7.28297 1.54323 -1.95967 +2186 4 8.75192 31.9258 4.24445 1.80419 26.3875 10.0131 +2187 6 5.53845 32.6958 11.4143 8.71933 -16.8124 -2.49586 +2188 4 4.77303 33.2403 11.6664 3.11219 -11.1916 -2.75881 +2189 4 5.22904 31.759 11.32 0.456358 25.4252 4.80969 +2190 6 45.6505 35.4572 20.4414 3.44959 -7.44503 -2.03407 +2191 4 45.0984 35.4295 19.6379 6.4013 -0.712815 7.57821 +2192 4 46.1919 34.6303 20.4513 -12.6908 13.7486 -3.45541 +2193 6 19.5117 2.78375 9.7759 -32.3978 -9.59039 -17.0694 +2194 4 19.2358 3.70482 9.71872 -0.134373 3.8207 4.89971 +2195 4 18.7417 2.29322 9.36028 25.7327 11.9734 13.3495 +2196 6 54.9587 9.07031 10.9149 6.82732 -5.63024 12.2566 +2197 4 54.8294 8.9199 11.8667 -4.4018 -2.06217 -5.32285 +2198 4 0.663346 9.73371 10.8556 1.49355 -0.124783 -2.42855 +2199 6 21.0387 26.5729 14.7801 20.1883 -1.49652 -44.4677 +2200 4 21.3075 26.2685 13.8316 -13.9911 15.8829 47.28 +2201 4 20.1009 26.3915 14.9175 1.72514 -4.1332 -5.78598 +2202 6 14.1556 30.5195 27.5512 33.9559 3.86758 5.7066 +2203 4 14.6157 30.1887 28.3748 -9.20473 8.28645 -28.3289 +2204 4 14.8625 30.9321 26.9648 -24.7422 -11.1229 20.6028 +2205 6 29.8153 17.3336 31.0863 -17.242 12.2647 2.89366 +2206 4 30.6608 17.508 30.6961 22.1461 -2.37775 -6.86255 +2207 4 29.3509 18.1813 30.9961 -0.156979 -6.11616 8.89085 +2208 6 50.8803 17.2897 27.8178 -36.3925 19.5692 4.68662 +2209 4 49.966 17.6961 27.8739 30.6942 -17.822 -8.40051 +2210 4 51.3989 17.8346 28.4178 4.99425 -5.86793 -0.268148 +2211 6 46.2649 37.0836 13.9834 -5.2064 -3.89214 -29.9265 +2212 4 46.1297 37.5324 14.8008 -1.4234 12.1478 29.9589 +2213 4 45.6025 37.4999 13.3985 5.55615 -7.46483 0.310394 +2214 6 38.1938 37.2652 33.1426 -7.30823 -21.5307 12.8964 +2215 4 38.5245 37.3061 34.0621 0.43181 3.22683 -10.2889 +2216 4 38.5338 38.0078 32.6437 8.99657 15.0472 -1.17828 +2217 6 41.835 13.3432 31.1173 -10.6585 13.9874 21.8211 +2218 4 41.5818 13.8647 31.919 4.55225 -14.0949 -20.2689 +2219 4 42.3932 12.6177 31.4161 6.34511 -7.13184 -1.29627 +2220 6 46.8964 12.6581 17.833 -7.85032 10.4907 -16.4819 +2221 4 46.6484 13.6178 17.7542 4.08188 -24.8978 -7.40371 +2222 4 46.6377 12.1709 16.9987 5.46876 16.7046 19.0746 +2223 6 32.0579 10.0934 10.6503 -8.64381 28.9058 -4.43215 +2224 4 31.7849 9.65569 11.4853 0.173068 15.3159 -11.0765 +2225 4 31.7767 11.0763 10.6467 12.4785 -48.8318 10.7993 +2226 6 34.0094 11.373 6.75969 12.8388 24.8548 11.4886 +2227 4 33.4875 10.5861 6.69386 -15.1181 -21.0438 1.83339 +2228 4 33.7853 11.7772 7.62543 1.85262 -6.17932 -11.7084 +2229 6 45.3294 30.8612 19.494 8.3992 -12.4908 2.66791 +2230 4 45.3133 30.6326 20.4263 -2.2594 2.91399 10.7741 +2231 4 45.8271 30.1094 19.1443 -2.81922 5.63857 -5.34771 +2232 6 20.3557 0.57205 7.14927 -0.865045 4.87397 8.36509 +2233 4 20.1887 0.590785 8.10086 -2.30268 5.48708 -2.96522 +2234 4 20.2885 41.5556 6.94299 -1.24307 -13.5357 -7.1472 +2235 6 15.9783 39.4524 4.13892 -0.0151964 -9.48015 -5.29824 +2236 4 15.6158 39.9898 3.41173 1.6648 1.85694 12.5404 +2237 4 15.64 39.7774 4.99485 -4.20756 5.15612 -10.0141 +2238 6 52.4256 16.4667 25.1127 -17.0507 13.8269 -2.02364 +2239 4 51.8848 16.9346 25.7614 0.982734 -7.60925 5.82434 +2240 4 52.3383 17.0704 24.353 8.48557 -12.5426 -0.219872 +2241 6 38.5361 13.0039 3.23845 15.1533 54.069 38.768 +2242 4 38.651 13.64 4.04305 -2.16968 -28.4467 -44.0011 +2243 4 38.0019 12.309 3.58724 -16.6469 -22.8542 0.297491 +2244 6 35.13 29.6899 31.1766 -32.8294 1.63854 50.8714 +2245 4 35.4825 30.1651 30.4465 16.0479 15.276 -26.3528 +2246 4 34.6741 30.3613 31.7643 12.1102 -21.125 -19.7306 +2247 6 9.51973 33.7498 4.86217 -21.8826 5.77433 4.68556 +2248 4 9.27059 34.3826 5.57285 8.50621 -13.5655 -12.6408 +2249 4 10.3866 33.3952 5.041 8.90701 -1.44023 3.12186 +2250 6 21.534 22.0642 20.5279 -11.3341 -5.53839 17.2976 +2251 4 20.8989 22.7675 20.339 3.51908 1.76985 -0.685914 +2252 4 21.3133 21.7346 21.437 6.74336 6.48682 -22.5749 +2253 6 37.579 11.1901 41.2936 -40.5688 -13.8213 19.6839 +2254 4 37.9154 11.8125 40.6731 20.8822 18.4609 -22.3708 +2255 4 38.2848 10.6639 41.6667 19.2795 -3.39896 1.21846 +2256 6 33.8862 1.42431 38.7362 -9.76991 -12.243 -0.11253 +2257 4 33.6023 0.553369 38.4181 2.20193 5.31751 1.25532 +2258 4 33.9041 1.3558 39.7008 -0.574955 5.51976 -3.65617 +2259 6 4.57166 26.6812 27.9899 28.8485 -45.5436 -4.48952 +2260 4 5.15229 25.8908 28.1565 -23.3183 20.9594 -13.553 +2261 4 4.90489 27.293 28.6243 -0.866291 24.6335 11.5543 +2262 6 10.2514 0.902381 11.6154 -4.58149 -17.6537 26.8062 +2263 4 10.6592 1.12475 12.4668 -4.26503 -7.612 -8.38981 +2264 4 10.5004 1.60734 11.0484 5.83944 23.9466 -26.0443 +2265 6 17.6545 19.8255 2.35686 18.7122 -0.118329 6.29025 +2266 4 17.9031 20.43 1.64019 0.754008 -4.0492 2.7955 +2267 4 18.4832 19.3436 2.60738 -15.0404 10.1651 -4.64219 +2268 6 32.418 25.6758 16.4635 3.6076 24.4214 11.9097 +2269 4 33.0171 26.0095 17.1449 -9.06157 4.09224 -4.99535 +2270 4 32.7904 24.838 16.2462 -1.14602 -28.0291 -11.1265 +2271 6 33.2468 10.6359 0.32388 9.93322 -26.76 -6.12289 +2272 4 32.8861 10.0042 41.5485 10.341 19.2926 16.9559 +2273 4 34.0854 10.2367 0.697563 -23.7256 11.8288 -10.1734 +2274 6 4.94758 4.52061 10.1416 10.7499 4.98188 17.9077 +2275 4 4.04768 4.863 10.1726 -0.273394 -4.88493 2.42241 +2276 4 5.29522 4.53942 11.0694 -10.4701 1.63881 -23.2648 +2277 6 27.0943 16.9779 9.5563 -20.4641 3.47693 -11.2288 +2278 4 27.2045 17.5151 10.3493 -1.38601 2.5137 2.70549 +2279 4 26.2214 17.2494 9.17658 21.4447 -4.2653 12.7286 +2280 6 9.99194 10.5198 19.3763 9.42123 -1.05348 44.8422 +2281 4 10.4342 9.89794 18.8118 9.85784 -12.5922 -17.5865 +2282 4 10.1605 10.162 20.3013 -9.67835 15.4527 -31.558 +2283 6 19.5738 8.53792 27.8563 25.8928 -1.13542 15.4327 +2284 4 20.113 8.77024 28.6584 -12.6361 -5.62488 -23.922 +2285 4 20.1113 7.87775 27.3567 -13.5748 14.3815 9.08869 +2286 6 47.0629 38.9588 23.1271 -13.9792 1.44752 0.432651 +2287 4 47.6691 38.8737 22.3925 4.22694 -4.47738 -4.61135 +2288 4 46.1776 38.8683 22.7344 3.33277 3.24373 3.79368 +2289 6 19.6833 25.3678 11.2608 -44.4501 -0.725843 0.650565 +2290 4 19.0139 24.6272 11.3182 24.6346 19.551 -2.60477 +2291 4 19.1544 26.1629 11.5326 10.4738 -19.1562 -5.87093 +2292 6 27.3884 13.4531 15.7313 17.4935 -10.3398 7.87305 +2293 4 26.7289 13.8255 16.2909 -22.225 11.7393 10.4827 +2294 4 28.1076 13.2654 16.3619 5.43008 -3.78237 -14.8549 +2295 6 18.6476 14.1287 1.42435 5.12245 -4.46092 -43.403 +2296 4 18.3969 15.043 1.25229 -6.07889 7.26273 6.76186 +2297 4 19.169 13.9274 0.593091 -12.995 -1.5013 29.2583 +2298 6 42.2956 22.0175 32.4812 -31.5033 5.69606 -11.9689 +2299 4 42.0953 21.6028 33.3343 -5.26012 -0.0861087 1.91793 +2300 4 41.4492 22.4721 32.2087 27.3869 -15.7461 8.96812 +2301 6 10.0338 9.4525 2.5044 21.0744 -25.1182 9.26795 +2302 4 9.23419 9.82009 2.8603 -22.4046 15.9317 4.21557 +2303 4 10.2146 8.68383 3.09556 -0.513225 11.8796 -14.6695 +2304 6 6.81454 1.43994 21.9965 -17.8896 2.42247 -7.4431 +2305 4 5.91626 1.63042 21.618 24.8197 -16.2049 7.25345 +2306 4 7.09146 0.513113 21.8391 -15.5061 11.1514 -4.64506 +2307 6 11.279 27.0428 18.9739 -2.94846 37.5248 -0.887691 +2308 4 11.8405 27.0241 19.773 -2.49358 0.901506 -7.48985 +2309 4 11.2189 28.0198 18.7087 3.35633 -32.7966 13.2637 +2310 6 41.4624 20.5117 27.2131 -8.71247 23.609 -19.3396 +2311 4 41.6397 21.203 27.8749 -2.09795 -12.5822 -0.139714 +2312 4 41.4581 19.6661 27.6488 3.25287 -9.08293 14.2442 +2313 6 15.4472 24.107 33.4286 7.47915 5.78269 -2.8589 +2314 4 14.6947 24.3175 34.0087 6.10264 -6.26217 -2.67023 +2315 4 15.704 23.1687 33.5026 -8.54671 4.87938 10.939 +2316 6 36.1332 16.3778 10.0175 -2.81296 8.13669 8.31829 +2317 4 36.0433 15.4982 9.63146 0.0153009 -3.05325 1.23302 +2318 4 36.1908 16.2895 10.9807 1.05799 -3.5475 -8.17119 +2319 6 51.7056 16.2618 2.12066 8.195 -18.8618 -27.7488 +2320 4 51.3212 16.7491 2.82948 -13.5116 6.32013 30.1636 +2321 4 51.8333 15.3227 2.36395 -2.62212 15.8907 6.5854 +2322 6 23.4154 8.54771 39.774 19.4785 -4.07885 -14.0827 +2323 4 23.6619 8.92799 38.8876 -4.40964 -10.2511 30.1282 +2324 4 24.1933 8.06554 40.1323 -10.8686 15.1901 -10.9325 +2325 6 36.7652 34.4407 21.0996 -10.7203 -4.0633 -8.35763 +2326 4 37.1575 34.5988 20.2292 -2.24352 0.118594 1.89686 +2327 4 35.7922 34.4168 20.9564 13.0606 -0.027129 3.88767 +2328 6 14.1394 8.88964 27.2822 8.4001 33.0473 -16.3093 +2329 4 13.5583 8.17177 27.4325 -25.1847 -27.8879 6.89622 +2330 4 14.9981 8.62308 27.6007 12.278 -0.771553 4.38 +2331 6 20.6523 37.4857 25.1916 -4.76336 -9.80096 2.89409 +2332 4 20.8435 36.6327 24.7231 -2.60537 24.8018 1.29013 +2333 4 20.5883 38.2205 24.557 2.95927 -14.0914 0.587832 +2334 6 28.8259 24.466 30.0361 -12.0182 1.20484 18.6414 +2335 4 28.1863 24.5363 29.306 15.5663 0.0495978 -2.57679 +2336 4 29.6571 24.0617 29.7579 -0.701354 -5.27936 -13.535 +2337 6 8.3767 11.9994 23.6977 15.286 -11.9681 20.7139 +2338 4 9.3753 12.0245 23.8359 -31.6027 -4.22616 -3.50543 +2339 4 7.96209 11.4264 24.4013 16.8905 14.3689 -13.5243 +2340 6 16.0974 26.6628 22.9497 0.767107 4.93659 2.67852 +2341 4 16.422 25.9025 22.452 -4.69466 0.466105 1.02544 +2342 4 15.3072 26.4353 23.4595 5.90508 -1.9072 -2.1838 +2343 6 22.3492 41.3933 9.48833 17.1541 -15.2597 3.14364 +2344 4 22.6076 0.330473 9.13574 5.89797 15.5422 -4.87712 +2345 4 21.4389 41.4869 9.73785 -21.2641 2.73615 1.78898 +2346 6 49.3865 19.1849 32.379 28.5034 -27.5288 -8.8444 +2347 4 49.9591 18.5119 32.8294 -20.0237 22.3317 -7.01358 +2348 4 48.8882 19.6696 33.032 -5.7885 3.32597 15.4548 +2349 6 29.6797 28.4194 31.2347 -18.17 -6.54897 12.3532 +2350 4 30.6054 28.3362 30.9452 0.112823 -13.8933 8.50124 +2351 4 29.3632 27.6339 31.7874 27.6893 19.0339 -22.4607 +2352 6 5.1089 39.1304 23.5821 16.3589 -26.7425 38.52 +2353 4 5.38369 38.72 24.4786 -14.1195 25.2427 -41.8592 +2354 4 5.12138 40.0884 23.679 1.29424 5.88982 9.05127 +2355 6 42.9406 13.5828 41.5963 2.4548 -20.3274 5.45752 +2356 4 42.752 14.3543 41.1051 4.71299 30.6973 -25.311 +2357 4 42.1302 13.4831 0.159852 -12.9765 -12.2431 17.3873 +2358 6 21.226 12.4267 7.36435 31.2446 -3.521 -2.03074 +2359 4 20.2961 12.4647 7.18572 -19.4619 -2.59914 -12.879 +2360 4 21.5838 11.6146 6.96487 -5.92297 6.31526 1.33966 +2361 6 43.1402 26.8798 37.6925 36.8226 -18.0871 25.2922 +2362 4 42.3701 26.4861 37.2457 1.92095 -10.9538 3.42147 +2363 4 43.8051 26.2366 38.1772 -44.9135 25.1765 -29.4158 +2364 6 19.5374 10.6589 41.6895 -5.57828 -38.0023 -10.1688 +2365 4 19.1336 10.6448 0.637369 -6.5477 2.89313 17.0607 +2366 4 19.8005 11.5407 41.5226 10.6711 39.664 -4.3781 +2367 6 53.6211 10.0725 3.2523 6.57913 5.47914 -9.18923 +2368 4 54.2317 10.83 3.34927 -4.54537 -9.93589 0.0420736 +2369 4 54.0384 9.44833 2.62164 -2.29754 8.8252 9.03809 +2370 6 17.5636 20.1992 28.4305 -16.5699 17.1528 15.5915 +2371 4 18.0548 19.7019 27.7957 9.40873 -10.9714 -15.8242 +2372 4 18.1497 20.2955 29.1876 1.50874 1.07066 2.83373 +2373 6 36.8673 7.33814 1.69171 -42.7001 9.70605 -8.47937 +2374 4 37.6788 7.60022 2.09727 18.2611 10.2246 9.26811 +2375 4 36.4242 8.16776 1.39628 11.5951 -12.345 5.16871 +2376 6 29.225 41.4226 1.83075 -19.1389 21.107 -1.05665 +2377 4 28.4254 0.0289368 2.09685 16.3458 -11.1471 3.47601 +2378 4 29.1672 41.4088 0.871311 7.531 -2.47214 -5.14574 +2379 6 13.5148 3.09025 8.11784 -10.8355 13.5741 -3.86075 +2380 4 12.8447 3.80664 8.08285 8.27234 -10.6709 -2.48032 +2381 4 13.8247 3.09872 9.02804 1.30446 -5.60755 1.07776 +2382 6 15.035 29.5824 18.5052 -13.3664 3.09019 -9.07378 +2383 4 14.628 28.8743 17.9722 6.78876 3.62049 6.93265 +2384 4 14.2975 30.1967 18.6986 12.8362 -2.82157 -1.1162 +2385 6 10.5118 24.7077 24.3903 18.3301 23.9761 -31.3173 +2386 4 10.707 24.7057 23.4146 -4.2845 7.89501 28.372 +2387 4 10.0612 23.8909 24.4849 -17.9274 -27.8 13.6507 +2388 6 2.3293 13.8562 25.1542 8.14415 -2.44132 2.05706 +2389 4 1.63302 13.4321 24.6436 -3.32338 -7.08116 -5.4939 +2390 4 2.0923 14.7815 25.112 -7.52471 9.11743 -0.122921 +2391 6 31.8571 32.759 29.7983 3.65167 10.3578 -8.56752 +2392 4 30.9277 32.9381 29.9784 -0.622435 -3.80813 0.732423 +2393 4 31.8884 31.8723 29.4276 -3.71181 -5.10697 -2.58235 +2394 6 37.531 40.8209 33.967 -23.153 -16.1875 5.3836 +2395 4 37.3251 40.1347 34.6985 0.870468 26.6491 -35.3147 +2396 4 36.773 40.8784 33.3102 18.3716 -9.25033 25.8989 +2397 6 24.0485 38.1313 34.3431 -11.5105 1.837 -35.773 +2398 4 24.1907 38.198 35.2802 9.24451 -7.73664 19.5979 +2399 4 24.4675 37.3552 33.934 1.62169 3.10325 14.1331 +2400 6 37.1852 22.5711 7.36841 5.54302 -17.8805 15.7599 +2401 4 37.6193 21.7136 7.5635 -9.24307 15.2983 -3.07678 +2402 4 37.2973 22.7156 6.43503 3.10694 -1.55352 -15.3513 +2403 6 4.30637 23.241 35.6005 -21.8515 -3.12039 0.833232 +2404 4 4.28153 22.3978 35.1252 -1.17938 4.50836 1.52069 +2405 4 3.36633 23.5034 35.7569 13.5984 -2.36814 -1.35472 +2406 6 15.7372 14.8984 2.68389 5.83394 8.18523 30.6602 +2407 4 16.0581 15.8209 2.80401 -5.66096 -17.7803 -6.78984 +2408 4 15.4195 14.7671 1.79524 0.865375 8.28049 -11.4308 +2409 6 48.1667 23.1873 2.04358 2.14857 -5.2771 -14.5053 +2410 4 48.6748 23.4267 2.82287 11.4848 0.866046 3.26637 +2411 4 48.7964 22.9219 1.32588 -13.3162 5.875 14.6145 +2412 6 24.1221 19.9752 21.5371 -32.3717 23.6383 6.86593 +2413 4 24.143 19.3917 22.3107 11.6246 -2.80692 -10.3828 +2414 4 24.7866 19.7762 20.8968 22.5091 -14.1667 -7.68302 +2415 6 10.5822 29.3968 5.14403 -6.21678 -11.6361 15.7318 +2416 4 9.83188 29.7897 4.67624 10.1791 9.93667 -6.35089 +2417 4 11.4324 29.7717 4.90568 -2.60747 8.99296 -10.7541 +2418 6 5.96985 27.6957 31.2251 14.0826 -21.4471 -14.909 +2419 4 6.62108 27.1001 30.7651 -15.2176 13.0885 7.83628 +2420 4 6.49554 28.1541 31.8886 3.5811 4.10899 4.91189 +2421 6 18.524 25.7945 15.3346 -6.80319 -1.26411 -41.3947 +2422 4 18.3129 25.8537 16.2191 -1.03447 -6.47723 71.4836 +2423 4 17.8509 26.3975 15.0287 -5.96066 9.61194 -22.438 +2424 6 52.0911 37.2147 11.1191 10.7944 -12.7592 -3.2574 +2425 4 52.6735 36.5031 10.7991 -6.06835 6.24709 5.19982 +2426 4 52.6754 37.9802 11.2539 -6.64808 -1.57102 -0.449092 +2427 6 46.8545 14.6154 7.32174 -10.4102 9.08531 6.17155 +2428 4 46.1761 15.2305 7.76384 29.9054 -34.6086 -7.32766 +2429 4 47.196 13.9114 7.91569 -13.0839 18.0399 0.731203 +2430 6 22.2426 0.701706 41.6733 41.1626 12.534 -29.9538 +2431 4 22.236 1.66756 41.6378 -9.79705 -6.68715 4.90956 +2432 4 23.0808 0.492341 41.1545 -29.2322 -0.545859 23.5967 +2433 6 4.06645 14.7285 9.26505 -5.79968 22.7562 -12.5209 +2434 4 3.53709 15.5501 9.07402 9.13976 -21.8289 3.48331 +2435 4 4.94549 14.9564 8.94351 2.1847 -1.50717 0.750146 +2436 6 37.293 12.6643 37.0348 -15.3153 -6.18171 16.0178 +2437 4 37.7524 12.8164 37.9019 -17.8573 -2.14895 -9.99561 +2438 4 36.3666 12.3049 37.1727 33.7628 8.85249 1.83374 +2439 6 26.6624 29.0693 40.5955 -26.637 27.4899 13.7151 +2440 4 27.0962 28.2693 40.8235 19.1059 -29.7051 -2.9078 +2441 4 26.7436 29.2635 39.6647 9.93266 -1.33043 -11.4317 +2442 6 7.23743 13.8563 3.32048 -33.1041 -30.3754 -14.41 +2443 4 7.96064 14.4301 3.56742 25.5688 -7.52041 0.820923 +2444 4 7.42976 12.8854 3.09984 6.81051 43.2082 15.4509 +2445 6 8.94797 34.8532 28.8254 23.4184 -23.2786 -12.4265 +2446 4 9.89546 35.0323 28.6727 -12.7097 -5.00209 3.03018 +2447 4 8.59604 35.6886 29.0779 -14.3686 23.8739 12.2374 +2448 6 37.2014 40.0808 40.1141 12.7521 0.43192 13.6168 +2449 4 36.2619 40.0837 39.9632 -10.4254 2.72875 -6.67898 +2450 4 37.248 39.4512 40.8496 7.71934 0.19736 -2.65382 +2451 6 30.3728 6.17428 27.2502 2.34222 12.9127 24.6773 +2452 4 30.0491 5.75377 28.1093 17.5599 21.8776 -23.7977 +2453 4 31.0277 6.90628 27.4549 -18.5498 -22.5685 3.02853 +2454 6 10.4851 22.8816 18.2947 -6.39025 -14.7202 -25.3901 +2455 4 11.3539 23.0451 18.66 8.78619 -1.44678 0.615593 +2456 4 10.601 22.3432 17.4702 -0.435219 15.7289 22.4338 +2457 6 35.9047 14.2516 40.1476 -11.9566 8.08227 -8.12446 +2458 4 35.3828 14.5983 39.4171 17.9635 11.5828 -3.36223 +2459 4 35.2535 13.6726 40.504 -8.36759 -16.975 21.7169 +2460 6 6.70775 1.0715 17.7189 7.50642 -21.2746 -7.36561 +2461 4 6.22784 1.34485 18.5084 1.44497 -10.5234 3.95628 +2462 4 6.91772 0.0894674 17.7256 -13.4419 30.1572 13.7277 +2463 6 41.3365 34.0623 33.1636 23.1157 -5.84267 13.8333 +2464 4 40.4227 34.234 32.9444 -15.3258 11.3352 -14.6542 +2465 4 41.9184 34.5849 32.5841 -12.4833 3.91505 -3.84565 +2466 6 37.2858 0.99342 41.2878 7.36827 13.3221 -16.8172 +2467 4 37.4859 0.112276 40.9658 -1.88555 -12.2628 0.361589 +2468 4 37.4834 1.0172 0.312287 5.29267 -3.40266 15.6364 +2469 6 25.2541 30.9749 6.2071 -22.7336 2.5299 17.3506 +2470 4 26.0217 31.2424 5.69829 1.89843 -3.96463 -15.2281 +2471 4 24.4182 30.8551 5.69564 23.045 5.74277 3.20871 +2472 6 14.1871 24.4929 28.313 -6.35756 40.4048 -1.58139 +2473 4 14.3311 23.6816 28.7714 -3.10946 -31.1704 -0.0360927 +2474 4 13.792 24.4319 27.4273 2.40698 -14.1025 6.50138 +2475 6 34.2078 26.2332 36.0169 -41.3887 31.6455 20.302 +2476 4 35.1375 26.2713 36.1926 18.3831 1.21525 6.50399 +2477 4 33.7458 26.9646 36.5669 26.0782 -29.6148 -21.0343 +2478 6 32.3696 8.32545 27.9988 -31.7689 14.924 14.5852 +2479 4 32.5206 9.30939 28.0669 10.5891 -30.1429 -9.37737 +2480 4 33.1235 7.86931 27.6333 20.3768 10.5357 -6.59273 +2481 6 11.7881 0.276326 26.9686 -1.26514 -24.1343 -2.09554 +2482 4 11.7898 41.2288 26.6922 -1.19404 21.3361 9.01519 +2483 4 11.5977 0.31005 27.9205 2.09711 -1.6438 -10.9729 +2484 6 1.68282 0.256654 10.3371 7.78574 -7.1909 -12.7427 +2485 4 1.59984 41.2742 10.69 -0.913761 -2.35777 -0.20094 +2486 4 1.41183 0.821253 11.0453 -5.61238 10.3042 16.839 +2487 6 6.75659 13.8554 8.24275 2.15336 8.75665 -12.4729 +2488 4 6.4538 13.9004 7.29654 11.603 6.79512 25.9161 +2489 4 7.29723 14.6482 8.44053 -3.39366 -6.31817 -8.96948 +2490 6 22.229 20.5516 6.16712 -19.4021 -6.23502 11.2792 +2491 4 21.7175 21.3783 6.29668 6.22315 -10.0472 -0.391558 +2492 4 21.7004 19.8262 6.58709 9.33903 15.1246 -7.94106 +2493 6 17.3809 20.4508 10.8712 -6.33142 3.08518 -4.04876 +2494 4 16.5461 20.08 10.4568 21.8919 23.129 5.85777 +2495 4 17.5363 21.4129 10.6625 -13.97 -26.3983 1.7074 +2496 6 17.7006 4.52466 19.5892 5.66371 -4.97651 -9.86024 +2497 4 16.9376 4.52739 20.1892 -4.06273 -5.34645 -7.80596 +2498 4 17.5412 3.84457 18.8839 -0.885651 16.9891 23.3258 +2499 6 0.475545 18.1168 40.0844 5.30586 -7.45209 -16.0452 +2500 4 0.255658 18.7395 40.7612 -0.602959 14.3131 10.4938 +2501 4 1.33302 18.3868 39.7002 -7.70736 -6.31105 3.74686 +2502 6 22.9439 24.8338 27.8349 -3.23408 23.09 -51.7359 +2503 4 22.7283 25.5292 27.1178 5.97449 -27.0764 31.3639 +2504 4 22.8278 25.2464 28.677 -4.11703 14.8593 21.0934 +2505 6 42.7959 39.1553 26.7627 -13.6288 14.9904 24.3142 +2506 4 42.9559 38.4383 26.1586 10.7263 -7.78522 -15.113 +2507 4 43.351 39.9224 26.5692 3.77188 -7.24305 -5.18193 +2508 6 26.2354 3.05796 21.7982 1.74018 25.1467 -10.7915 +2509 4 25.6923 3.78105 22.1642 10.9011 -13.8467 -3.1836 +2510 4 26.7888 3.50003 21.1142 -10.0122 -11.5362 10.4851 +2511 6 54.6007 9.88011 29.5829 2.61324 -0.835643 16.9334 +2512 4 53.983 9.1383 29.6239 1.49377 0.577448 -2.59463 +2513 4 54.746 10.0983 30.5296 -2.21833 -1.79811 -18.9561 +2514 6 24.7578 33.7363 20.5387 -17.5006 5.04967 -0.0763559 +2515 4 24.6934 34.6555 20.8512 7.60819 -4.12262 3.6003 +2516 4 23.9235 33.6132 20.0554 5.3121 -3.42637 -1.44671 +2517 6 41.6963 16.3109 0.897802 2.88421 10.066 -28.0255 +2518 4 41.3077 16.0362 1.70176 -16.3219 -5.78099 30.2108 +2519 4 42.6299 16.1901 1.06805 12.6035 -3.11322 -2.97519 +2520 6 23.404 27.9303 27.4821 -1.06023 20.2241 -21.3645 +2521 4 22.8141 28.2554 28.1835 2.551 -1.87769 -8.73241 +2522 4 23.2629 28.4828 26.6516 2.17993 -16.4871 31.3925 +2523 6 32.7813 37.2936 18.7328 38.5641 -14.7697 6.75932 +2524 4 33.752 37.1016 18.9061 -34.9795 -0.437252 0.892363 +2525 4 32.8311 38.1729 18.3762 -6.70298 14.6722 -8.07554 +2526 6 21.2305 27.6771 4.7955 -18.4608 -25.795 -24.9287 +2527 4 20.5062 27.4644 5.39651 2.92048 5.31567 1.45057 +2528 4 20.941 27.2184 3.94502 12.5509 18.4099 23.8236 +2529 6 54.9409 17.9571 1.83459 -7.07205 6.42915 6.55936 +2530 4 54.7029 17.1381 1.42965 7.06691 -21.815 -7.49321 +2531 4 54.119 18.4405 1.74821 -9.38537 8.8513 -0.363257 +2532 6 36.7335 10.6984 6.58912 -34.5362 -0.324761 -4.53473 +2533 4 35.7609 10.9799 6.6143 34.1258 -12.1011 2.72213 +2534 4 36.7696 9.77633 6.90859 -3.13742 6.31851 -1.30765 +2535 6 54.2706 4.50024 14.0257 -11.269 5.99606 -15.4247 +2536 4 53.8536 5.11876 13.3604 4.87759 -11.992 26.1673 +2537 4 53.895 4.59469 14.9192 -3.76531 8.72829 -7.53187 +2538 6 22.107 12.8255 32.0148 27.0088 -6.82073 4.3703 +2539 4 21.2061 13.1328 31.8952 -10.7145 6.62508 -9.34344 +2540 4 22.7298 13.2576 31.3917 -17.4011 -3.99159 8.00208 +2541 6 15.2931 36.6619 4.04206 -24.4039 12.3238 20.1693 +2542 4 15.3606 37.6342 3.9855 6.08423 -9.62309 -2.22716 +2543 4 16.0243 36.2999 3.55051 12.1414 -1.28609 -8.9598 +2544 6 23.9518 1.27347 5.70825 1.82336 16.8815 15.3992 +2545 4 23.158 0.731739 5.71694 -5.31944 -7.03749 -3.2154 +2546 4 23.9846 1.73289 6.57368 -1.26671 -8.46254 -14.2674 +2547 6 14.3069 12.6571 15.8074 -11.3886 -13.8779 -22.9988 +2548 4 14.4908 12.4438 14.8835 17.1875 4.58775 1.43504 +2549 4 13.3991 12.3171 15.8566 5.60683 8.95198 18.2444 +2550 6 15.0463 40.2277 6.58272 -14.4539 15.1029 5.15073 +2551 4 15.8086 40.489 7.08192 22.3652 -6.01515 7.9389 +2552 4 14.4962 41.022 6.75392 -6.77819 -16.9793 -13.6053 +2553 6 48.5629 32.6194 12.091 2.37027 -5.84764 -3.4739 +2554 4 48.1048 31.8776 11.6348 7.57669 12.4587 1.43975 +2555 4 49.3373 32.9111 11.5511 -18.0393 -12.2542 5.39731 +2556 6 11.2883 31.5349 7.21941 -5.75599 -10.1169 -16.3625 +2557 4 10.675 30.8987 6.79271 12.7122 10.5617 8.56414 +2558 4 11.681 32.0415 6.48473 -4.52974 -6.63428 7.17241 +2559 6 30.1204 27.9925 10.216 2.65146 5.67665 0.571004 +2560 4 30.7332 28.7325 10.019 -7.63861 -11.6097 -0.594568 +2561 4 29.9063 27.5181 9.39417 2.857 4.22172 -1.33476 +2562 6 27.6817 22.1076 17.3717 2.13561 -8.21554 7.46684 +2563 4 27.3138 21.4721 16.7296 5.88092 9.15558 -3.1228 +2564 4 28.0594 22.8778 16.9197 -3.27829 -5.84867 -5.86393 +2565 6 12.9588 4.5965 18.1625 2.45174 -26.8216 -12.137 +2566 4 13.4346 3.75914 18.3684 -5.38503 16.4797 0.486183 +2567 4 12.5704 4.4145 17.2814 1.35975 11.1796 8.84538 +2568 6 19.7171 6.72206 19.0824 18.7149 18.1076 8.78634 +2569 4 19.0276 6.07043 19.1643 -12.8479 -14.7766 2.48779 +2570 4 20.149 6.78349 19.9504 -8.03044 -1.70313 -8.42964 +2571 6 37.158 31.386 11.4948 13.5333 -6.17925 -0.534196 +2572 4 36.3748 31.5241 12.0574 10.6691 -10.2998 8.4252 +2573 4 37.8298 30.7884 11.9154 -26.2348 9.80485 0.777976 +2574 6 3.12167 16.2038 27.3537 -19.2499 -26.3416 -14.9115 +2575 4 2.564 15.4232 27.613 17.9651 21.4634 -3.17821 +2576 4 3.05771 16.2343 26.3741 -0.0558506 5.44355 20.7735 +2577 6 15.7152 9.97508 38.3617 37.2659 20.4939 22.6587 +2578 4 16.1689 10.8384 38.1525 -17.0523 -25.976 5.55091 +2579 4 16.2475 9.64647 39.1327 -18.0975 2.21635 -20.7757 +2580 6 13.3945 14.2914 8.22355 52.7406 24.0557 20.8129 +2581 4 13.9343 15.0997 8.53617 -32.8018 -27.7376 -11.9171 +2582 4 14.0669 13.5802 8.35008 -24.0553 1.67412 -6.96019 +2583 6 1.72299 24.3133 36.3936 32.5837 -28.3335 21.1288 +2584 4 1.96116 25.1215 36.8464 -1.44419 12.4956 -1.11134 +2585 4 1.10799 24.5417 35.7277 -24.491 15.1488 -24.3141 +2586 6 11.1925 26.5189 32.9725 1.88857 3.23229 20.5962 +2587 4 10.9062 26.8258 32.1286 -6.138 -2.28585 -27.1412 +2588 4 11.0637 27.2989 33.5293 3.02186 -7.15206 7.83107 +2589 6 29.5898 0.769141 36.29 0.770047 10.6645 18.3277 +2590 4 29.1085 0.54227 35.5145 -3.81283 -13.529 -27.0487 +2591 4 28.8904 1.11515 36.8518 6.86702 4.29265 4.12775 +2592 6 43.6054 13.1224 23.9122 -2.46968 6.93561 -17.1322 +2593 4 42.8447 13.3401 24.4619 -4.47847 1.10283 0.728731 +2594 4 43.3126 13.2067 22.9653 4.50753 -0.208477 27.3689 +2595 6 7.45217 19.7807 19.6677 5.33955 -1.6221 -12.877 +2596 4 6.80427 19.1226 19.9251 -3.45906 -4.13396 8.35684 +2597 4 7.46466 19.745 18.7046 0.226191 5.91599 3.73904 +2598 6 24.4186 4.28854 7.83154 -9.27237 -3.93777 -5.86373 +2599 4 24.1141 5.19611 7.95791 2.72117 -5.11917 -0.666563 +2600 4 25.0574 4.07609 8.5187 1.73531 2.38301 -0.0162684 +2601 6 51.4783 30.2365 31.1578 4.43663 8.1051 17.8753 +2602 4 50.5719 29.9409 31.3316 -1.01079 -0.531629 -9.26743 +2603 4 51.6665 30.2531 30.2149 -6.58635 -1.64064 -12.0931 +2604 6 0.928618 23.6677 16.8891 39.1558 -2.20072 16.2176 +2605 4 0.0728448 23.4362 16.5368 -6.93512 -13.3273 -6.91209 +2606 4 1.45563 22.867 17.1505 -20.9828 13.2836 -9.64814 +2607 6 45.0876 19.3948 15.692 7.86589 27.8079 -34.4593 +2608 4 45.9117 18.9264 15.546 6.38244 -8.87865 2.87525 +2609 4 44.6429 18.9609 16.3882 -19.7965 -22.2098 30.8606 +2610 6 17.4975 8.71947 40.5884 -15.3884 33.6574 -8.04213 +2611 4 18.1832 9.38307 40.741 -0.0730079 1.31818 -0.306908 +2612 4 17.9142 7.90906 40.8182 15.4372 -26.466 6.58932 +2613 6 30.1853 27.2566 27.195 -12.9952 17.3445 1.1523 +2614 4 31.1231 27.467 27.0889 -0.851996 0.391463 0.93648 +2615 4 29.6983 28.1205 27.2412 18.1484 -22.709 -4.59112 +2616 6 43.0643 26.2027 28.3545 -5.31946 22.0639 -20.7107 +2617 4 43.281 25.753 27.5201 1.76973 -3.45008 6.18356 +2618 4 43.0898 25.5645 29.0616 2.35339 -12.574 6.70826 +2619 6 27.9963 7.58777 3.05558 10.5798 9.34284 19.8534 +2620 4 28.0446 6.83168 2.47717 -2.58104 -14.3156 -10.0889 +2621 4 28.509 7.35692 3.86128 -6.64638 2.01122 -8.68086 +2622 6 44.6822 7.22369 10.1895 -15.4824 21.4485 13.7445 +2623 4 44.4465 7.45383 11.1264 7.27839 -9.51736 -18.1425 +2624 4 45.2115 6.42757 10.2073 4.94307 -7.89984 8.76143 +2625 6 23.5336 20.3897 32.2571 -4.86538 -1.36788 -16.1605 +2626 4 23.3032 21.2113 32.7104 1.28111 0.523216 5.34569 +2627 4 23.9774 19.8232 32.8948 2.81274 0.218846 6.19737 +2628 6 37.5478 21.0473 29.278 -18.5062 7.79735 6.57819 +2629 4 37.2371 20.358 28.6908 4.72073 -14.165 -12.1471 +2630 4 36.7158 21.4163 29.628 13.2175 4.90017 2.66375 +2631 6 49.286 29.0703 28.699 10.8186 8.22027 -9.31733 +2632 4 48.7028 29.7991 28.456 -10.3299 -0.414367 -0.610456 +2633 4 50.1517 29.4276 28.433 0.637469 -9.81751 4.99071 +2634 6 47.52 18.1671 15.2208 -2.7229 30.7912 -34.1138 +2635 4 48.0078 17.7317 15.8928 12.2019 -13.0526 25.5862 +2636 4 48.0044 19.0008 15.0204 -10.6208 -16.322 3.06818 +2637 6 23.2448 11.1727 16.5931 -14.8157 -11.6244 -0.308602 +2638 4 23.8342 11.8286 16.2582 11.4387 21.3683 -6.30591 +2639 4 23.6559 10.3501 16.3116 -3.14365 -5.23997 2.15847 +2640 6 3.13911 8.33446 23.1963 -2.69702 8.14317 3.16076 +2641 4 3.4034 7.82956 22.4196 3.11719 -1.75335 -2.44085 +2642 4 3.61355 9.18537 23.1574 -2.855 -3.87959 1.25156 +2643 6 0.502965 16.1866 6.18545 3.06312 3.24934 37.7622 +2644 4 1.47856 16.2897 6.04903 -24.0003 -4.70784 4.68468 +2645 4 0.309706 16.1237 7.18858 13.4295 2.89967 -42.1744 +2646 6 43.1771 15.7066 5.83749 -5.07319 -7.51407 -5.60477 +2647 4 43.0136 16.4204 6.43488 -7.5966 11.2789 14.4199 +2648 4 44.0623 15.8898 5.5251 15.5631 0.134699 -7.60204 +2649 6 16.7019 35.4798 34.4572 -11.2013 7.16284 28.6023 +2650 4 15.9782 34.9492 34.0738 5.35466 1.61493 8.45244 +2651 4 16.3895 35.7941 35.362 6.52255 -9.83405 -29.4813 +2652 6 38.8822 7.74245 15.6771 24.467 26.2162 11.5837 +2653 4 39.1941 7.06316 15.0707 0.325231 -3.95447 -5.25413 +2654 4 39.6937 8.2709 15.9758 -30.2905 -22.5291 -12.0432 +2655 6 42.0043 36.5204 13.6369 3.57579 19.2035 0.0265624 +2656 4 41.9371 35.5667 13.6578 -6.58441 -9.91584 1.38486 +2657 4 41.1548 36.8737 13.3269 0.670997 -7.61264 0.497391 +2658 6 54.2965 15.3698 32.1203 7.94984 -1.57724 11.6593 +2659 4 0.00278476 15.9714 32.4364 -1.97539 -6.90512 -0.0853595 +2660 4 53.6257 15.9484 31.7567 -4.83125 0.736868 -4.95397 +2661 6 22.8953 13.994 39.0277 29.317 0.766946 3.70607 +2662 4 23.2673 14.8115 39.3939 -3.87119 -6.48985 -1.20924 +2663 4 21.9724 14.1463 38.894 -27.0425 2.87882 -4.26486 +2664 6 48.0413 28.5291 4.79053 -11.6037 -2.58599 22.6989 +2665 4 48.6027 28.7991 4.07655 16.555 3.34212 -19.6439 +2666 4 47.7045 29.3636 5.15455 0.064426 -0.719185 3.47056 +2667 6 48.8324 10.6079 2.66689 -4.06073 -3.45613 -38.269 +2668 4 48.225 10.1372 3.21562 -13.339 -11.2438 14.6703 +2669 4 49.3888 11.1314 3.20945 16.7197 17.33 23.918 +2670 6 17.1017 29.3417 4.42129 -6.1746 1.2215 19.6287 +2671 4 16.2515 28.9749 4.73431 4.06151 0.983408 -5.41825 +2672 4 17.5169 29.7258 5.22535 1.37581 -6.66399 -13.2687 +2673 6 27.7925 7.31966 26.5665 39.3465 35.5797 -5.30427 +2674 4 28.7629 7.09708 26.703 -34.5848 -6.71948 -0.628584 +2675 4 27.2286 6.57009 26.6643 -1.86949 -31.2701 4.24572 +2676 6 18.0221 22.0409 22.5172 -16.5701 10.2349 -21.3339 +2677 4 18.5639 21.2383 22.5163 -1.8186 -3.43948 -8.36361 +2678 4 17.5144 22.1102 21.6408 22.068 -10.0871 32.2991 +2679 6 22.1395 25.0891 16.7042 -20.9036 23.9116 7.05274 +2680 4 21.7854 25.6501 15.9625 11.5166 -19.4533 18.3362 +2681 4 22.5191 24.3092 16.3181 5.92374 -8.20656 -11.3677 +2682 6 25.488 28.4523 7.12785 -10.8823 -15.9396 20.8595 +2683 4 25.4981 28.5494 8.12476 3.48758 8.16016 -33.1398 +2684 4 25.5521 29.3092 6.69674 -1.4246 11.8198 7.49476 +2685 6 42.5416 24.7341 23.7389 -17.4504 20.5814 2.46415 +2686 4 41.7374 25.1978 24.1118 21.637 -12.0739 -8.95046 +2687 4 42.3838 23.7928 23.8344 -7.43983 -12.597 1.84916 +2688 6 6.22002 16.6178 2.47863 15.1987 22.5956 5.3052 +2689 4 5.33799 17.0017 2.41879 -13.1624 -14.3434 -0.0608379 +2690 4 6.24934 15.6649 2.55192 -10.5885 -12.312 -0.729605 +2691 6 47.3735 33.281 1.45237 -1.26376 -9.34891 -34.4477 +2692 4 47.004 34.1558 1.53803 -0.151384 8.42018 6.19826 +2693 4 47.7374 33.0316 2.29181 5.29029 2.56444 17.845 +2694 6 1.28124 36.1882 24.8833 15.6174 10.404 -23.7919 +2695 4 0.591937 36.4933 25.4703 -7.67557 -4.15788 11.0948 +2696 4 1.63511 35.375 25.2549 -3.92235 -3.89482 10.8998 +2697 6 20.9296 29.0485 16.4244 -14.8946 8.72798 0.140185 +2698 4 21.4494 28.4837 15.8729 6.14594 -21.5718 -11.6475 +2699 4 21.5122 29.7657 16.643 5.64358 11.2813 6.66084 +2700 6 18.6504 32.5428 14.1464 30.5599 1.70581 -2.73789 +2701 4 17.8579 33.056 14.2705 -20.3424 -4.20043 8.80032 +2702 4 18.5989 31.5954 14.3835 -16.0449 10.8642 1.76069 +2703 6 15.729 41.6925 0.00385817 -5.28292 -15.868 -0.0471225 +2704 4 15.6317 41.084 41.1283 -1.722 11.921 23.9575 +2705 4 15.1873 41.3899 0.782005 8.67232 1.52126 -23.9336 +2706 6 20.5292 18.4098 7.21323 -2.91221 4.89049 5.17577 +2707 4 20.2914 18.5583 8.16487 -5.028 -0.721877 -18.2737 +2708 4 19.7413 18.3526 6.62958 8.30767 0.291632 18.8261 +2709 6 35.3342 2.82915 1.61883 3.51298 26.3767 19.1091 +2710 4 35.0331 3.19583 2.50754 16.3791 -7.36031 -35.2043 +2711 4 35.9206 3.53855 1.22039 -16.4006 -18.5858 14.5973 +2712 6 48.9922 19.6721 24.94 -34.075 0.0390245 -1.22883 +2713 4 49.8199 19.2352 24.7823 16.5976 -0.114011 -0.96393 +2714 4 49.1617 20.6125 25.0649 5.94448 -3.86752 4.03728 +2715 6 26.0294 7.18427 41.5679 18.6543 -22.0446 -14.9111 +2716 4 26.7755 6.56315 41.735 -11.6555 11.6244 -4.08136 +2717 4 25.6575 7.3193 0.515359 -11.3234 5.2253 22.1616 +2718 6 22.0232 3.61039 29.0191 -5.74486 -2.38085 -7.46091 +2719 4 21.2539 3.82496 28.4513 11.98 3.27859 6.66273 +2720 4 22.2148 4.35673 29.5966 -4.60401 3.08527 0.791206 +2721 6 27.8512 32.5337 20.6565 16.709 -10.0789 14.6393 +2722 4 26.9625 32.7469 20.4552 -34.4793 1.21347 -3.16249 +2723 4 28.3469 33.1233 20.1026 12.1012 5.18966 -5.24336 +2724 6 8.41229 24.7869 3.46082 22.3386 15.1563 9.53263 +2725 4 8.90357 24.2552 2.84068 9.55631 -8.44952 -10.853 +2726 4 7.60423 24.3318 3.61908 -22.8615 -12.1417 2.22131 +2727 6 30.5897 41.7312 15.6484 22.6974 7.2585 28.5546 +2728 4 29.9644 0.0840213 16.3484 1.9076 -3.76769 -8.41354 +2729 4 30.1014 41.5664 14.8669 -20.7398 -7.21626 -25.2002 +2730 6 48.088 5.62638 21.1953 6.60529 -8.20232 0.106871 +2731 4 47.6746 6.34733 20.7055 -8.23977 -5.05625 1.96425 +2732 4 47.4017 5.06013 21.5879 -0.150274 10.975 -6.21391 +2733 6 39.4216 23.1741 35.7526 -24.6601 -13.9913 -21.1364 +2734 4 39.9113 23.6202 36.3986 28.8985 24.9348 33.8823 +2735 4 38.8958 22.5444 36.2533 -4.57276 -5.65639 2.90172 +2736 6 51.5794 33.3637 5.78804 -15.2387 -43.0642 -16.4958 +2737 4 51.7543 34.264 5.94613 8.32006 43.2545 8.99501 +2738 4 51.5314 33.243 4.82206 1.27667 3.09716 8.04215 +2739 6 40.1245 17.6149 30.7901 8.56984 -3.86721 -1.09973 +2740 4 39.7659 18.4612 31.0527 -2.58034 0.199434 5.42908 +2741 4 40.7245 17.8709 30.0792 -0.880063 -10.8459 -3.09375 +2742 6 46.409 9.80599 18.5787 -10.6525 10.5445 16.3312 +2743 4 47.1858 10.3579 18.4839 1.73901 1.20814 1.97642 +2744 4 46.4156 9.2339 17.8265 -1.18405 -17.3223 -19.0152 +2745 6 15.8964 41.084 31.9275 -7.67529 -16.3413 6.36199 +2746 4 16.5726 40.6297 31.3851 0.744388 15.1086 2.48527 +2747 4 16.0838 0.121849 31.9545 10.6182 0.477469 -6.79561 +2748 6 48.5579 25.7373 14.9245 -32.9201 0.62376 14.4593 +2749 4 49.4842 25.8337 14.7718 19.5896 2.21134 -17.0603 +2750 4 48.049 25.8802 14.1037 15.4245 2.93063 1.46628 +2751 6 39.2312 28.9787 36.1455 -14.672 -4.00104 3.01304 +2752 4 39.9934 29.3216 36.628 6.25522 6.25199 -7.03146 +2753 4 39.4638 28.7366 35.2366 10.4577 0.0924929 -3.6403 +2754 6 37.3289 21.0516 14.9314 -10.8689 -7.09111 1.49701 +2755 4 38.071 20.892 14.3011 -28.0288 10.0477 -1.14031 +2756 4 36.4673 21.3942 14.5393 36.2132 -8.93414 7.14583 +2757 6 32.4934 22.8531 15.7417 3.10645 -11.4389 20.7178 +2758 4 31.7266 22.539 15.2235 4.17967 -1.79737 6.20971 +2759 4 32.6084 22.2825 16.5528 -7.19864 12.5613 -26.7488 +2760 6 18.5678 8.15053 37.5885 12.1963 17.253 1.38788 +2761 4 19.2402 8.85275 37.7813 -15.6951 -12.294 2.78452 +2762 4 17.9606 8.11124 38.3342 2.60008 5.05619 4.87993 +2763 6 46.9436 30.3797 11.0104 1.88703 -1.83756 -2.66296 +2764 4 46.4577 30.6986 10.2121 16.8565 -15.5671 12.8865 +2765 4 47.4104 29.5424 10.7815 -11.8828 15.01 -3.66074 +2766 6 54.6316 13.0448 30.6676 -4.47091 -6.8042 2.85617 +2767 4 54.8929 12.2323 31.1402 -1.2342 7.60269 0.15722 +2768 4 54.6603 13.771 31.309 -0.297949 0.849652 -1.52079 +2769 6 32.2951 35.1224 27.9786 -1.77947 21.9995 15.3623 +2770 4 32.2792 35.8643 28.662 -2.01418 -27.5067 -15.3374 +2771 4 32.1621 34.2527 28.3767 0.559318 -0.0892981 14.8897 +2772 6 4.45055 25.4036 31.7899 -1.02142 -16.2715 16.4968 +2773 4 4.99753 24.9958 32.4777 -6.33224 -6.47315 3.67169 +2774 4 4.91071 26.2154 31.6821 9.55032 31.2277 -12.9728 +2775 6 40.7771 38.1434 21.8579 6.80518 1.6634 -4.63259 +2776 4 40.7449 39.0581 22.1203 -10.5616 15.8809 15.9679 +2777 4 41.4448 38.2055 21.1733 6.63637 -13.627 -11.1518 +2778 6 26.6799 9.85647 27.3982 -25.6987 30.8747 18.2417 +2779 4 27.0738 9.12687 26.9584 7.64189 -30.2216 -11.3166 +2780 4 25.7862 9.62595 27.7363 13.5029 -2.01996 -6.34848 +2781 6 53.4177 39.431 11.7682 60.4327 6.90374 -14.3662 +2782 4 54.4363 39.4906 11.5459 -51.7213 -2.15349 13.0324 +2783 4 53.0514 40.2823 11.4531 3.65586 -10.6921 6.91198 +2784 6 35.3318 21.4177 2.24537 5.41769 -12.1321 -20.1082 +2785 4 34.8431 20.6225 2.51379 1.47903 7.83344 1.83382 +2786 4 35.7036 21.1864 1.3528 -11.9529 6.47568 24.5243 +2787 6 4.13637 17.136 33.9211 3.37621 -12.3766 5.67686 +2788 4 4.20441 16.396 34.5697 -7.88327 11.3141 -11.775 +2789 4 3.23668 17.1493 33.5445 4.32036 -6.23827 5.33579 +2790 6 24.1551 16.173 14.6595 0.905264 -13.203 -15.7913 +2791 4 24.2344 17.0724 14.9677 3.21898 8.1818 3.14137 +2792 4 23.7074 16.2777 13.8038 1.81958 -4.41422 2.08172 +2793 6 43.135 2.84466 26.1032 13.1229 6.35408 -5.68313 +2794 4 42.2875 3.17639 26.414 -4.49653 4.08553 -4.30298 +2795 4 43.2684 3.17059 25.1875 -5.24638 -3.17663 12.7173 +2796 6 40.6938 12.184 1.56501 -11.5288 -7.07153 -25.6549 +2797 4 41.6237 12.1687 1.8186 -0.151998 5.09311 17.9246 +2798 4 40.0653 12.4844 2.24465 11.7671 0.703669 4.7582 +2799 6 47.3771 8.09383 26.755 61.1653 27.2124 16.0462 +2800 4 46.6352 7.69428 26.3774 -33.8593 -24.2939 -29.8281 +2801 4 48.1554 8.02079 26.1437 -24.5213 -4.41693 14.2109 +2802 6 35.8722 30.7298 38.4929 46.7797 8.20249 -0.795626 +2803 4 35.8437 29.9971 39.0885 -23.8052 -20.0767 8.1402 +2804 4 36.8495 30.8926 38.5637 -31.083 11.8011 -18.5205 +2805 6 51.2951 23.2205 32.4921 -21.4102 17.5258 -2.96787 +2806 4 51.6315 24.0445 32.1105 -0.705735 5.94923 -0.836877 +2807 4 52.0737 22.714 32.6486 16.7198 -16.4886 4.04233 +2808 6 30.6141 4.4461 39.6711 -15.3731 3.79473 -35.0115 +2809 4 30.9464 3.61986 40.0176 9.77962 -4.83986 19.2734 +2810 4 30.7704 5.18568 40.2576 9.11216 5.26318 14.244 +2811 6 35.2646 29.7051 2.85778 -14.8887 -12.395 -20.7058 +2812 4 35.7986 29.7272 2.02588 -11.2321 -1.99949 14.2373 +2813 4 34.4405 29.1492 2.64359 32.9241 21.0754 6.44042 +2814 6 50.3111 26.1454 9.40098 -22.1621 10.9454 -20.0185 +2815 4 49.986 26.7793 8.71172 15.2241 -16.6208 13.1315 +2816 4 49.7063 25.388 9.31525 11.793 4.08785 3.97386 +2817 6 50.0869 36.8245 26.4088 -20.9012 -6.38176 7.71076 +2818 4 49.5586 36.0705 26.7514 3.9746 5.79943 -8.74909 +2819 4 50.1941 37.3864 27.1871 4.41306 8.36789 0.548966 +2820 6 40.3119 23.9565 38.5384 47.4279 -1.39254 -15.5521 +2821 4 40.88 24.732 38.748 -21.3925 -13.0784 -2.40019 +2822 4 39.4343 24.1145 38.8527 -20.1214 13.5622 11.7594 +2823 6 24.9444 10.7496 30.6663 31.051 18.5451 27.0394 +2824 4 25.7305 10.8456 31.2787 -28.4 -7.1047 -26.2292 +2825 4 24.8995 11.6269 30.2371 -7.15612 -14.1049 -2.61146 +2826 6 5.89131 1.01728 5.39947 -5.16247 -17.9253 -0.227043 +2827 4 5.22088 0.340863 5.59281 2.49468 7.88844 1.50452 +2828 4 6.71299 0.544267 5.57411 4.99832 4.76302 -4.28882 +2829 6 44.2927 29.3807 26.2764 43.728 -18.4205 -0.18667 +2830 4 43.5018 29.5461 25.816 -39.4067 7.83222 -12.62 +2831 4 44.7851 28.7616 25.699 -3.50466 6.32584 16.51 +2832 6 25.3064 10.1814 6.6654 -6.94402 -15.718 -9.61204 +2833 4 25.6542 11.0594 6.61048 6.10034 18.8978 1.37462 +2834 4 25.5624 9.77067 5.8255 0.943829 -2.29537 1.40094 +2835 6 13.3606 28.0664 2.58456 21.0736 -2.27515 1.79417 +2836 4 12.4645 27.8304 2.42125 -25.9451 -0.745297 2.44011 +2837 4 13.7867 27.7237 1.79619 10.8353 3.06046 3.23802 +2838 6 6.45257 40.24 18.0133 20.0379 8.33657 1.98834 +2839 4 6.89988 39.3931 17.8777 -5.14522 -3.62214 0.392952 +2840 4 5.56311 40.1207 17.6969 -15.0406 -3.82351 -6.06839 +2841 6 47.8011 13.5056 2.01844 -10.5648 -21.267 23.3214 +2842 4 48.1524 12.6081 2.17165 -2.87721 6.43796 -2.24674 +2843 4 48.4275 13.9546 1.48105 20.9852 11.6376 -18.273 +2844 6 13.5939 20.3067 2.43603 17.8956 14.689 14.157 +2845 4 13.8339 19.6256 3.09172 -4.40777 3.66463 -6.9739 +2846 4 12.9598 19.9059 1.86118 -14.8369 -10.3601 -11.305 +2847 6 15.2334 0.8368 36.6591 1.55142 7.70692 -22.3998 +2848 4 15.2542 1.38367 37.4773 0.960764 -3.32816 -20.1037 +2849 4 15.3344 1.45306 35.8608 -4.23652 -17.7771 37.8382 +2850 6 33.6147 35.2459 15.1 16.7734 -11.8793 -18.4599 +2851 4 33.8163 35.2873 16.0538 13.2499 -3.34836 -12.9991 +2852 4 34.4154 34.9808 14.5294 -23.6504 9.8312 34.8639 +2853 6 21.8005 9.23588 0.431159 13.8262 -19.7524 30.0596 +2854 4 22.4067 9.05801 41.6249 5.27322 -0.932182 -12.5411 +2855 4 21.1072 9.74412 0.0564903 -22.836 18.1195 -16.0408 +2856 6 38.1565 27.4627 3.04439 18.4183 -28.2807 7.84104 +2857 4 37.7322 27.3164 2.21113 -4.60599 -14.2952 -24.3043 +2858 4 37.7632 28.2451 3.34335 -13.6136 36.2365 19.5187 +2859 6 38.8873 27.196 11.7739 15.5044 -8.33717 -5.93911 +2860 4 38.7841 26.3327 12.232 6.37868 6.61944 -11.5261 +2861 4 39.5786 27.1133 11.0659 -17.5863 -8.28826 19.2684 +2862 6 29.8757 41.5959 28.7066 13.5858 28.49 -11.3766 +2863 4 28.9647 41.3014 28.7466 -9.40406 -2.02578 1.88502 +2864 4 29.8997 0.254331 27.9025 -2.68961 -11.7418 13.302 +2865 6 34.0266 8.72323 38.0698 33.719 9.40995 4.6971 +2866 4 34.8877 8.24089 38.094 -11.378 13.1352 -1.62724 +2867 4 33.3712 8.08689 37.8245 -20.4874 -15.945 -8.86187 +2868 6 38.8142 27.3472 30.6886 -7.48306 -22.0573 -0.58069 +2869 4 38.4096 26.5151 30.3537 9.19692 16.3236 1.53567 +2870 4 38.2655 27.5885 31.4334 -4.0026 6.56393 5.14207 +2871 6 41.6513 17.2644 36.3568 8.49285 18.5772 4.12306 +2872 4 41.236 17.1887 35.5016 -7.55839 -3.54967 -10.3568 +2873 4 41.7813 16.3888 36.7033 1.22956 -17.0266 1.65102 +2874 6 30.7157 26.9788 35.2038 -10.151 -4.28381 0.0670681 +2875 4 31.4488 27.4236 34.7965 20.0965 0.384289 -13.2747 +2876 4 30.343 27.6484 35.7639 -8.80839 6.96039 12.3672 +2877 6 47.5342 4.10778 27.2888 11.6095 8.93875 26.3727 +2878 4 46.6105 4.27591 27.501 -8.38331 -0.425724 -4.8003 +2879 4 47.5988 3.99389 26.3497 -6.2541 -0.220522 -17.1995 +2880 6 20.9412 8.38521 7.26575 -18.1268 -17.2637 2.68033 +2881 4 20.8809 8.87169 8.08328 -6.592 1.96128 21.9757 +2882 4 21.4179 8.98778 6.73029 19.5174 18.1449 -30.7672 +2883 6 36.8608 13.6781 0.872276 -22.567 18.0135 -7.8322 +2884 4 37.3857 13.5342 1.64823 18.2236 -14.2068 17.6988 +2885 4 36.9649 12.9376 0.269125 7.56106 -9.0363 2.17502 +2886 6 28.5805 20.3012 26.4498 13.4935 0.222411 -13.7489 +2887 4 28.4835 19.3803 26.2016 0.90122 -3.21423 2.30104 +2888 4 27.7964 20.5416 26.9224 -18.5183 5.12398 12.3317 +2889 6 51.6021 16.8515 33.5179 -11.2544 -15.3 0.627003 +2890 4 51.563 16.0241 34.0301 0.916298 4.09207 -0.753195 +2891 4 51.0058 16.6639 32.7753 6.31462 4.20327 -0.345536 +2892 6 16.2626 32.019 37.6812 -31.2107 -29.2496 -22.9287 +2893 4 16.4537 31.3803 38.4011 -2.23747 12.829 -12.3594 +2894 4 15.5373 31.5705 37.1079 31.9743 21.1891 23.5065 +2895 6 14.3366 25.8859 13.2055 -16.2598 35.1345 -7.65407 +2896 4 13.5591 26.1022 13.7538 4.79106 -9.45955 4.66587 +2897 4 14.3924 26.7004 12.6499 8.67511 -16.0651 4.90492 +2898 6 54.9632 28.863 3.30225 1.80665 -46.0259 4.02989 +2899 4 54.8334 28.8705 2.33571 2.30679 -1.29159 7.0988 +2900 4 0.250446 27.9134 3.53944 -11.9885 37.0888 -10.0107 +2901 6 17.2065 5.13222 2.58226 -24.5489 -19.7693 -14.9516 +2902 4 17.8239 4.45011 2.8785 5.4716 1.45995 5.40018 +2903 4 17.4096 5.93537 3.0482 10.2082 3.99522 6.08435 +2904 6 50.7076 33.0524 10.3335 3.48719 10.0002 9.95533 +2905 4 50.6136 33.804 9.75033 0.0726689 14.8217 2.89741 +2906 4 50.6632 32.3255 9.72979 -1.7797 -23.5385 -6.20373 +2907 6 28.8719 19.8379 32.3662 12.2168 9.43689 -9.94144 +2908 4 29.8293 20.0527 32.223 -26.7315 -2.75674 4.09206 +2909 4 28.3919 20.677 32.2058 6.96369 -8.55206 2.54368 +2910 6 22.4258 12.8301 23.3099 -21.9068 12.8519 23.6974 +2911 4 22.5424 12.4187 24.2055 -3.2327 9.70973 -17.8182 +2912 4 21.6904 13.4906 23.4219 18.0295 -16.5223 -3.23075 +2913 6 54.7859 15.5473 8.87871 3.42684 8.57095 -7.37477 +2914 4 0.5152 15.244 9.45304 -3.41058 -4.28924 6.32649 +2915 4 53.9742 15.1056 9.16818 6.16615 -2.4265 3.01646 +2916 6 10.455 19.2982 26.169 33.281 -8.93788 40.2277 +2917 4 11.227 18.6906 26.1605 -15.5014 12.2348 -4.03004 +2918 4 10.0694 19.2521 25.3251 -19.4777 -1.76614 -41.28 +2919 6 38.6541 20.3016 35.2246 25.1317 -2.89776 0.584273 +2920 4 39.6122 20.389 35.0245 -16.8563 1.20482 1.7302 +2921 4 38.6037 19.6498 35.9401 -3.42784 5.37932 -3.92632 +2922 6 17.4847 18.0451 15.2473 -2.11698 43.6037 15.5575 +2923 4 17.3165 17.6253 14.4157 -4.81229 -12.7227 -25.2707 +2924 4 17.3243 19.0143 15.0283 6.45297 -29.0578 8.37137 +2925 6 29.6412 0.96029 26.2538 -2.92598 -32.1867 -14.968 +2926 4 29.2295 1.80722 25.9783 -5.05853 -19.2177 -5.0061 +2927 4 29.2302 0.136786 25.7855 11.2507 47.838 14.1271 +2928 6 30.4583 12.6781 28.2933 9.80318 -11.3268 12.128 +2929 4 29.9046 13.1756 27.6811 -9.35495 -4.05719 -6.55314 +2930 4 30.1425 11.7563 28.3949 -4.92949 12.905 -7.65094 +2931 6 36.6582 22.1039 33.3564 18.5548 3.44171 -30.7077 +2932 4 37.613 21.8793 33.4826 -21.695 5.78572 4.26475 +2933 4 36.1698 21.8632 34.1249 -2.38139 -6.6943 29.4942 +2934 6 34.851 22.4634 14.295 34.3706 -12.4795 -36.6647 +2935 4 34.1306 22.5878 14.8998 -26.9044 -0.864951 1.69223 +2936 4 34.6097 22.0485 13.4154 -10.7342 10.9778 31.0087 +2937 6 15.5278 9.60588 7.43972 42.9889 -30.8008 -13.2318 +2938 4 16.5289 9.52064 7.17624 -51.4641 3.68278 11.9177 +2939 4 15.1523 8.68078 7.51431 10.3517 24.0811 1.24627 +2940 6 21.8097 28.0449 19.8036 -9.3837 2.2861 -3.69714 +2941 4 21.8234 28.4749 20.6579 1.49564 5.45585 8.79124 +2942 4 20.892 27.7474 19.715 3.3935 -2.50466 0.747966 +2943 6 34.5377 24.4067 2.43307 17.6783 -35.0943 7.08511 +2944 4 34.5604 23.3833 2.29911 9.6022 45.0517 12.0591 +2945 4 35.2671 24.6922 3.07368 -22.5652 -15.0324 -19.8681 +2946 6 12.5974 20.9324 33.5156 -46.2472 -18.3539 -4.34371 +2947 4 11.7028 20.621 33.8238 24.9199 8.0821 6.3307 +2948 4 12.4411 20.8933 32.5604 17.1824 5.4367 5.76912 +2949 6 45.7726 31.1546 8.70236 -14.9606 25.5026 -0.599968 +2950 4 45.9029 32.1319 8.75243 4.68257 -18.3747 -3.63409 +2951 4 44.8252 31.0158 8.86685 6.58294 -2.27884 -1.49072 +2952 6 15.4856 22.546 30.183 -27.3843 -7.95278 -8.87715 +2953 4 16.2041 23.1276 30.4314 15.0704 -4.03687 4.09321 +2954 4 15.7065 21.6006 30.174 10.2057 11.8959 3.83923 +2955 6 39.7496 17.1848 38.4183 10.7213 7.86871 6.49434 +2956 4 39.4778 16.5926 37.6964 5.17631 5.73732 3.80123 +2957 4 40.5328 17.6892 38.1152 -12.3514 -12.5856 -1.70264 +2958 6 14.0114 24.6894 0.67727 2.36324 3.45559 -2.63023 +2959 4 14.2236 24.5974 1.61702 0.728832 5.12592 -0.706901 +2960 4 14.3876 25.5307 0.374588 3.08684 -2.75846 6.71077 +2961 6 31.517 19.5744 3.57234 -39.7066 16.7987 -9.47084 +2962 4 30.9812 19.3042 4.35775 22.6375 1.42354 -10.5596 +2963 4 32.4299 19.3292 3.64982 19.3858 -12.3464 7.87151 +2964 6 36.0836 25.0594 19.4567 -36.7914 6.39304 28.0525 +2965 4 37.0156 25.1955 19.4145 23.7106 3.97855 -3.98164 +2966 4 35.8434 24.7134 18.6052 0.797557 -6.28507 -17.3783 +2967 6 51.6689 17.6827 14.8094 17.1445 12.5774 26.8045 +2968 4 51.9037 18.5572 15.2299 -9.72171 -22.1194 -12.5657 +2969 4 51.1779 17.9239 14.0295 -8.26923 9.08158 -15.405 +2970 6 37.7112 27.5006 38.1887 12.9616 35.4771 9.449 +2971 4 37.6633 26.7956 37.5532 1.11487 -12.4995 -15.1422 +2972 4 38.1924 28.2458 37.7567 -11.1334 -22.4905 3.32353 +2973 6 34.7974 13.8528 30.7792 38.2139 14.8122 -13.8353 +2974 4 35.0479 14.6237 31.2931 10.1718 6.91547 -1.09557 +2975 4 34.0108 13.6012 31.1887 -47.9834 -23.6229 17.9792 +2976 6 19.6227 37.378 39.9679 -4.73731 -6.94245 -18.3615 +2977 4 20.5687 37.4692 40.1123 7.88808 5.09103 7.87528 +2978 4 19.5641 36.8976 39.1176 -6.21843 3.50671 7.67834 +2979 6 40.9479 34.0678 21.4433 -0.249567 -14.1225 -18.8789 +2980 4 41.1016 33.9428 22.3797 -2.14769 -1.67588 5.36328 +2981 4 40.6839 33.1793 21.1286 -1.36491 12.9737 -0.808456 +2982 6 32.9563 27.2052 26.5619 16.765 25.3633 38.6423 +2983 4 33.6584 27.782 27.0193 -28.2502 -21.1678 -18.3317 +2984 4 33.3196 26.985 25.7164 10.2198 -2.00428 -21.725 +2985 6 24.4119 18.6722 15.6191 2.60565 2.56356 0.790403 +2986 4 23.5591 19.1036 15.7005 -5.06369 4.62453 -0.705819 +2987 4 24.5532 18.2558 16.4735 3.02917 -4.75652 8.16225 +2988 6 29.9677 1.63803 9.07283 -8.6377 39.5876 -9.34009 +2989 4 30.0634 0.720354 9.20948 2.18912 -36.9171 5.61628 +2990 4 29.1461 1.70687 8.54641 9.48634 -0.985828 6.78106 +2991 6 31.4838 20.0989 7.86304 35.53 0.0326438 -30.7549 +2992 4 32.0429 19.6076 7.17649 -26.3889 9.76992 30.1887 +2993 4 30.8408 19.4752 8.19414 -7.49558 -12.7978 -1.24617 +2994 6 35.0504 3.77818 33.2765 0.0823497 -0.922868 12.9261 +2995 4 34.3448 4.25588 32.7981 8.7563 -3.59111 2.91721 +2996 4 34.8655 3.9194 34.2319 -2.64551 -3.11561 -17.2257 +2997 6 43.9652 7.96842 12.9746 -1.99776 -12.8019 0.966431 +2998 4 43.3695 7.30717 13.3748 13.3395 3.08022 -2.86187 +2999 4 43.3917 8.71398 12.8108 -3.39849 12.2944 -1.42541 +3000 6 44.1076 32.6848 16.9531 4.83347 14.0385 -4.8226 +3001 4 44.7886 33.3699 16.7553 -9.08835 -13.3706 7.91806 +3002 4 44.1269 32.547 17.9059 1.63547 3.97279 4.50154 +3003 6 40.604 27.1617 19.037 5.49217 0.683783 -24.0967 +3004 4 39.907 26.5243 18.7614 10.7357 10.4426 0.818988 +3005 4 41.0572 27.5561 18.2306 -16.7517 -14.1941 23.9583 +3006 6 46.0503 23.2068 29.0603 33.2935 27.7725 23.492 +3007 4 46.7239 23.8517 29.4252 -26.0483 -15.0892 -12.6312 +3008 4 46.5249 22.3737 28.9794 -1.25341 -9.22801 -2.13192 +3009 6 42.6264 30.606 18.8462 -34.271 -0.881878 -8.8004 +3010 4 43.5242 30.7893 19.1074 18.3218 -5.88078 -5.57768 +3011 4 42.5428 29.9264 18.1492 10.4183 2.57162 5.03187 +3012 6 36.1231 10.8975 23.2614 14.248 33.6052 6.96597 +3013 4 35.2264 11.248 23.1278 1.11349 -2.62395 -2.03304 +3014 4 36.6438 11.7125 23.5215 -18.5882 -27.5405 -10.5609 +3015 6 13.7387 31.5187 15.7175 -8.63655 -3.85126 -4.64142 +3016 4 14.6788 31.7096 15.8046 0.813603 4.25462 -2.48371 +3017 4 13.3439 32.0503 15.0041 7.14664 -1.81478 4.34843 +3018 6 33.1663 41.4263 27.7844 10.1514 -8.73892 50.1834 +3019 4 33.0558 0.0915148 27.0508 0.335607 20.6114 -25.4934 +3020 4 33.386 0.0476391 28.6 -4.59167 -12.6797 -24.4066 +3021 6 32.8924 22.9248 31.4777 14.8331 -14.2772 -3.0724 +3022 4 32.331 22.9976 30.6823 -4.11553 14.0534 8.76104 +3023 4 32.7731 23.648 32.1168 -12.639 5.72297 -14.9522 +3024 6 27.6514 16.8629 6.392 5.9792 -3.02818 28.7598 +3025 4 27.8554 17.3015 5.57876 -0.492343 9.99532 -20.1105 +3026 4 26.7867 16.4634 6.29535 -11.4685 -3.6273 -5.68351 +3027 6 47.2692 11.6326 26.0701 -7.51592 -12.561 -4.95541 +3028 4 47.0451 11.5188 27.0189 12.1951 16.3083 -15.426 +3029 4 47.7234 12.4489 25.7723 -5.45211 -2.19527 19.0308 +3030 6 27.5533 7.05227 7.64253 19.1893 -9.34804 28.5196 +3031 4 26.7486 7.45205 7.94122 -22.9318 8.15137 -1.85106 +3032 4 28.0959 7.04706 8.46187 -1.51515 -0.839126 -23.0353 +3033 6 39.7861 9.0687 11.9758 -15.1444 6.22431 -7.98147 +3034 4 39.495 9.25597 11.0599 4.77492 -2.72739 13.3066 +3035 4 38.9879 9.23938 12.5098 3.46881 -0.389139 -2.20355 +3036 6 18.1894 33.4728 36.1008 -27.5283 -9.1571 7.06889 +3037 4 17.6722 33.9726 35.425 4.94426 -9.47891 13.9641 +3038 4 17.5468 32.9442 36.6812 19.6546 19.0371 -24.2711 +3039 6 37.1945 26.5569 0.720807 -12.4444 8.19753 -2.53971 +3040 4 37.3568 25.6462 0.476597 4.7119 -6.04631 0.679389 +3041 4 36.2336 26.6328 0.585525 8.76389 3.8419 -0.879611 +3042 6 44.2004 19.6233 36.8917 26.7932 -13.3754 0.0595121 +3043 4 45.0387 19.0956 36.766 -19.227 18.7818 5.02367 +3044 4 44.4376 20.5683 36.9644 1.27086 -9.01627 -1.91077 +3045 6 27.7799 6.35317 35.6882 16.2858 -3.70231 1.18314 +3046 4 27.1634 6.96571 35.2926 -9.46908 3.45363 -4.90602 +3047 4 27.3042 5.53742 35.858 -2.00694 0.00942349 2.38052 +3048 6 34.7653 16.4924 20.8795 20.4023 -19.0949 10.3746 +3049 4 35.5516 15.8729 20.9898 -30.5098 25.2475 -4.70775 +3050 4 34.1298 16.2162 21.5757 7.90375 5.70636 -13.0995 +3051 6 39.0303 20.9673 40.4307 -20.4786 -67.2325 12.8224 +3052 4 38.8254 20.089 40.9106 11.5443 40.6977 -30.184 +3053 4 39.2642 21.5386 41.1412 8.11615 27.562 18.514 +3054 6 10.8068 27.9205 1.65866 27.4379 7.91142 -24.506 +3055 4 10.0967 27.7204 2.22826 -30.9372 -12.069 25.0324 +3056 4 10.8782 28.8813 1.73209 2.10338 1.16742 -2.23752 +3057 6 47.025 23.1272 13.2603 -26.8307 -11.5375 0.419605 +3058 4 47.6563 23.6094 12.7175 1.22463 1.60122 -3.88323 +3059 4 46.2701 22.846 12.6737 25.4538 5.98786 18.4886 +3060 6 34.5769 28.3999 10.6617 -26.3731 9.09486 -11.6064 +3061 4 34.5145 27.7223 11.3448 13.7244 -2.44185 1.37306 +3062 4 35.5023 28.5375 10.4336 6.33869 -4.76798 1.2135 +3063 6 3.33738 17.579 14.2816 -4.12164 13.1786 -2.02309 +3064 4 3.51487 16.7052 14.5979 -0.480238 -24.8864 6.17379 +3065 4 3.96197 18.0965 14.8055 -3.35437 6.17503 -1.46632 +3066 6 27.7248 11.5976 7.52038 4.0705 34.1711 4.34085 +3067 4 27.7194 12.5939 7.6487 2.26317 -33.1326 -4.66749 +3068 4 27.2616 11.2314 8.28138 -1.22149 -2.70865 2.4378 +3069 6 41.4317 28.339 9.02961 12.1835 18.6619 -21.5911 +3070 4 40.932 28.9387 9.57928 -8.65956 3.59764 13.3257 +3071 4 41.6711 28.9179 8.26221 -0.754142 -18.9314 12.3863 +3072 6 42.0732 4.78493 8.18399 0.592074 10.501 -23.0953 +3073 4 42.2656 5.73441 7.90258 -4.03181 -32.5079 3.94615 +3074 4 41.9391 4.19656 7.39311 5.50228 24.8072 19.85 +3075 6 28.4553 8.6408 40.3288 -1.1592 2.81238 -0.593175 +3076 4 27.8014 8.47839 41.05 3.29603 2.13238 -25.5829 +3077 4 28.0374 8.68456 39.4248 -2.58083 -3.24862 30.0681 +3078 6 0.723272 18.248 15.2854 4.61761 3.31073 11.0333 +3079 4 1.58056 18.1517 14.8782 17.0637 -0.561901 -5.4503 +3080 4 0.169553 17.7112 14.727 -13.9143 -7.94922 -7.42873 +3081 6 7.11829 16.2161 40.455 0.573222 -5.60735 -16.9123 +3082 4 7.21814 15.2583 40.7035 1.10072 25.2259 14.7352 +3083 4 7.17549 16.8833 41.1741 1.82325 -21.1089 2.38217 +3084 6 41.0856 8.6232 20.9154 1.44565 10.3804 -0.748136 +3085 4 40.3857 8.53297 20.2693 -12.0873 -13.8416 -3.91841 +3086 4 41.3541 9.53003 20.731 8.87844 6.62655 8.68036 +3087 6 31.7065 7.41805 37.5384 1.8504 0.880847 10.656 +3088 4 31.4927 7.12037 36.644 -5.569 -4.06437 0.235955 +3089 4 30.9766 7.14703 38.1182 6.88034 1.43502 -8.9471 +3090 6 40.7175 11.6353 25.4105 -5.83472 20.1078 -6.29096 +3091 4 40.8441 12.5768 25.6218 -9.59803 -8.51017 -7.38463 +3092 4 41.5254 11.2592 25.7328 13.3582 -17.7026 5.353 +3093 6 29.8893 30.1615 6.66958 6.45784 -4.04896 -4.41327 +3094 4 30.5285 30.6751 6.15191 0.92206 -5.81994 -1.29615 +3095 4 30.2313 29.249 6.64761 -0.535397 8.70224 -1.24193 +3096 6 40.83 24.591 5.67679 17.1105 23.9162 -4.99229 +3097 4 41.4401 25.3556 5.89599 -18.0089 -21.1831 -4.73113 +3098 4 40.1352 24.5742 6.32932 -4.29697 2.2625 8.62223 +3099 6 34.3954 9.09122 20.4203 -0.702674 2.95809 7.47625 +3100 4 33.5897 9.50113 20.7506 -0.63314 5.38769 7.97821 +3101 4 34.107 8.76785 19.5728 -0.194313 -9.82044 -16.4611 +3102 6 18.2164 33.5433 26.5438 32.3972 -29.6611 -30.5808 +3103 4 19.1929 33.4142 26.4527 -23.3283 -2.37285 -6.48837 +3104 4 18.1915 34.0681 27.3044 -13.0981 29.1765 42.7321 +3105 6 28.9207 17.4075 26.7926 -1.66434 -4.11711 9.90999 +3106 4 28.2497 17.0259 26.21 0.151798 0.605301 -3.15085 +3107 4 28.4243 17.7127 27.5796 8.50802 -3.38176 -8.48604 +3108 6 50.4389 35.5612 18.195 -0.220837 -24.3132 -9.08897 +3109 4 50.4331 35.2145 17.2813 -0.853004 14.3463 8.17747 +3110 4 50.3692 34.7248 18.6968 -4.07606 17.1918 3.62275 +3111 6 2.99582 21.5586 31.4575 0.708202 -18.646 -28.6731 +3112 4 3.24926 22.2892 30.8424 -5.67023 -11.8068 12.1364 +3113 4 2.8516 20.7624 30.8616 4.12476 24.3831 20.6408 +3114 6 36.1857 18.7483 8.60511 9.96184 26.1081 -2.68835 +3115 4 36.1356 17.8778 8.93402 3.95956 -36.7917 21.724 +3116 4 35.6171 18.7388 7.85438 -14.2398 9.24248 -24.4438 +3117 6 20.2742 6.47995 33.7286 -0.427153 4.78104 -4.08195 +3118 4 19.8935 6.35632 34.6244 -2.14212 -11.6635 -12.611 +3119 4 20.0876 5.70362 33.1559 -1.45185 1.76636 16.8362 +3120 6 13.9952 30.5211 6.65468 -0.834568 0.374695 7.89925 +3121 4 14.6781 31.0539 7.1149 -10.4447 -7.07426 -7.17019 +3122 4 13.1432 30.7212 7.07951 7.79461 1.02333 -2.73826 +3123 6 36.2732 16.4484 35.7639 18.345 14.0335 0.961522 +3124 4 37.2268 16.2475 35.9495 -24.6333 8.21497 -3.5549 +3125 4 36.1837 17.4253 35.5797 7.74798 -29.1845 4.36862 +3126 6 45.8208 37.6575 9.69399 14.3507 -31.8621 -27.6249 +3127 4 45.4608 38.3019 10.268 -8.06385 16.394 26.7739 +3128 4 46.3975 37.0305 10.1733 -1.81999 10.6315 0.898341 +3129 6 47.4165 17.984 27.6369 4.10759 -46.3966 -5.45297 +3130 4 47.5682 17.4629 26.7823 -7.01073 17.4072 30.8444 +3131 4 47.4562 17.3293 28.4007 0.542452 20.9274 -25.5144 +3132 6 25.9608 18.2932 0.952258 -4.39486 21.5955 18.9376 +3133 4 26.1989 18.9101 1.66086 12.5057 -8.35286 -7.15646 +3134 4 25.0082 18.3237 1.04468 -12.1408 -13.2893 -13.6751 +3135 6 27.3648 22.4066 4.28268 2.26175 -24.9034 0.419816 +3136 4 27.3706 23.3409 4.46802 1.80952 16.8807 -5.51915 +3137 4 27.3027 22.2785 3.32806 -2.77408 5.10873 4.5687 +3138 6 3.39125 3.84856 27.607 3.69966 -10.1033 0.490887 +3139 4 4.0137 4.55908 27.5406 6.78149 24.6072 0.911673 +3140 4 3.97847 3.09168 27.5281 -8.4044 -12.3732 0.103181 +3141 6 45.3633 27.6554 28.8452 2.12727 -1.25659 10.7713 +3142 4 44.5282 27.2015 28.6866 -4.83999 -4.58212 3.48715 +3143 4 45.3811 28.2979 28.14 4.63148 6.41932 -6.37453 +3144 6 28.4005 32.3772 16.2203 23.7034 -3.75626 0.763822 +3145 4 29.2297 32.2225 15.6968 -18.0553 4.16843 14.9752 +3146 4 28.6795 32.6874 17.1033 -0.325788 -1.29005 -11.6373 +3147 6 9.90477 33.835 13.0292 3.70295 -3.7397 30.9684 +3148 4 9.58558 33.3049 13.7992 6.56164 12.5415 -12.6178 +3149 4 9.32425 33.6546 12.2978 -12.2649 -3.83445 -16.8068 +3150 6 38.3301 26.6316 14.917 8.16845 -9.374 -1.40965 +3151 4 38.7482 25.7736 15.154 -10.3234 14.7528 -2.05039 +3152 4 37.3847 26.6122 15.1206 3.66029 -5.29 2.35016 +3153 6 31.3553 16.3729 4.24558 -11.5598 -13.3523 13.2112 +3154 4 30.5395 15.8971 4.54084 13.4071 7.11555 -7.19651 +3155 4 31.205 16.607 3.32285 -2.62497 2.93757 -4.30077 +3156 6 6.17611 3.41063 6.5613 17.7272 3.64487 37.5473 +3157 4 6.46982 3.08663 7.46094 -9.0795 17.2981 -27.883 +3158 4 6.02642 2.6045 6.08389 -2.81663 -13.5692 -12.3872 +3159 6 42.5919 12.9938 5.62253 0.302259 -11.3067 -0.460125 +3160 4 42.3001 13.8766 5.84478 4.87778 6.39543 1.2284 +3161 4 43.5084 12.9049 5.92305 -2.35353 0.46184 -1.33783 +3162 6 41.0467 31.3953 33.7949 3.79599 37.3117 5.16998 +3163 4 40.7289 31.3961 34.7173 5.05156 -5.30154 -15.2916 +3164 4 41.2174 32.3636 33.5809 -4.47671 -37.1445 4.47908 +3165 6 52.8595 12.0576 26.2617 4.7779 -12.5882 -49.4794 +3166 4 52.3971 12.713 26.7564 -13.8804 18.303 15.9364 +3167 4 52.6839 12.2865 25.2977 8.87889 -9.64762 29.5111 +3168 6 39.2197 4.29237 29.0569 11.235 6.95972 3.08537 +3169 4 38.4782 4.84799 29.3396 4.36118 -6.50894 -4.0878 +3170 4 39.9967 4.59393 29.5615 -4.77927 -7.36273 -4.89832 +3171 6 3.64414 27.0065 11.2815 -12.9441 10.9516 -6.43872 +3172 4 4.59106 26.8908 11.2849 14.3058 -9.72403 4.26042 +3173 4 3.53535 27.8319 10.7781 -8.82957 -2.80904 -0.131447 +3174 6 41.5421 29.6442 25.2671 -5.6293 3.19366 2.66863 +3175 4 41.8684 29.6903 24.3723 12.1179 -3.11764 -10.4285 +3176 4 40.7194 30.1326 25.2057 -6.30215 2.63585 1.74894 +3177 6 50.468 27.487 30.6705 -3.05594 -10.4468 2.57161 +3178 4 50.076 27.1594 31.5009 0.806547 4.01213 -5.24181 +3179 4 49.8217 28.0451 30.2184 -2.62753 1.96724 1.87939 +3180 6 32.7902 33.6258 41.7496 -4.87138 -4.97834 -25.0012 +3181 4 33.1641 32.7497 41.8541 3.47816 -11.5824 1.65798 +3182 4 32.8969 34.0586 0.665858 3.16614 12.7166 21.4132 +3183 6 5.9796 9.64598 7.93234 5.57207 13.1841 -10.7861 +3184 4 5.80592 9.95912 8.82583 -0.986272 -0.521215 4.5825 +3185 4 6.43021 10.3852 7.47125 -1.05258 -10.6241 3.31462 +3186 6 52.774 25.3768 27.6816 12.7732 -3.18466 28.0173 +3187 4 52.93 26.2779 28.0237 -8.60677 -10.695 -13.1321 +3188 4 53.2011 24.8527 28.4031 -8.37753 -2.27765 -26.5487 +3189 6 18.6947 23.2095 14.4724 -28.0966 8.43578 15.8218 +3190 4 18.5587 24.1605 14.7523 20.6562 -24.296 -13.1918 +3191 4 19.5669 23.0215 14.1303 11.4888 10.4676 -1.8787 +3192 6 31.2862 9.0706 13.0896 18.8649 -43.5027 -8.26415 +3193 4 31.2854 8.18164 13.5153 -0.98006 14.2242 -7.24428 +3194 4 30.8139 9.64196 13.6614 -21.2648 23.3567 24.384 +3195 6 52.8349 16.8368 29.9626 -1.04236 -5.83632 -3.7224 +3196 4 53.1314 16.3317 29.1809 4.11254 10.2245 6.81583 +3197 4 53.5336 17.4658 30.2088 5.59995 -2.32318 -6.64835 +3198 6 13.48 30.6403 11.9185 -26.7 12.8254 18.6299 +3199 4 12.8874 31.2649 12.4086 6.11749 -21.3055 -11.69 +3200 4 14.2712 31.1662 11.9231 18.3999 3.72963 -5.07782 +3201 6 24.4118 24.6653 11.1776 -11.0488 -38.9105 0.0232616 +3202 4 25.2327 25.0345 11.4834 15.6111 8.28781 8.86477 +3203 4 24.5324 23.6736 11.237 -9.01076 27.817 -2.51724 +3204 6 11.1207 26.7925 5.93063 -6.41259 2.09364 -8.23675 +3205 4 11.5241 26.98 6.79711 -3.12879 8.72791 -6.17468 +3206 4 10.8719 27.6544 5.50988 6.7003 -18.2386 15.7162 +3207 6 12.0069 32.3194 4.56559 -6.93674 1.89769 -53.2748 +3208 4 11.7104 31.8608 3.68045 16.1117 25.2499 46.2442 +3209 4 12.3686 33.2222 4.3326 -9.20365 -26.1492 2.14142 +3210 6 6.43611 5.48582 30.4705 10.9412 7.27018 -5.81208 +3211 4 6.8324 6.31983 30.1884 15.302 -0.761667 0.276275 +3212 4 5.5204 5.70213 30.4126 -22.6187 -2.98333 3.5448 +3213 6 38.1723 39.6045 29.3805 -11.1368 -0.968084 -7.99101 +3214 4 37.5332 40.3179 29.1036 12.1085 -24.1545 -0.917311 +3215 4 37.9804 38.7063 28.9788 -2.28765 36.4506 5.30967 +3216 6 52.5924 19.3736 5.41149 4.12965 0.0949992 -5.17576 +3217 4 52.3027 20.2712 5.07121 22.7239 -28.0308 -2.84369 +3218 4 53.4989 19.0543 5.10701 -28.7609 25.7225 2.66162 +3219 6 18.3561 9.81057 21.0683 -18.476 -24.6523 15.6829 +3220 4 17.6378 9.45854 20.4828 20.1245 14.4878 5.80252 +3221 4 19.033 10.2869 20.5982 6.82627 10.6552 -20.9713 +3222 6 14.5094 41.1238 15.0395 5.73538 -4.06503 -13.1796 +3223 4 15.2839 41.068 15.6075 4.55031 0.900939 7.74817 +3224 4 13.875 41.6599 15.5263 0.0235554 2.15182 4.98288 +3225 6 36.0027 23.903 26.7597 7.48895 21.6763 -35.676 +3226 4 35.8975 23.6043 27.6465 2.36908 -17.7227 17.2904 +3227 4 36.3267 23.2124 26.1374 -7.97178 4.49324 27.7844 +3228 6 35.6359 10.4157 26.2529 -13.2839 -25.1837 23.1485 +3229 4 35.969 10.5098 25.3716 5.3977 0.436992 -21.1808 +3230 4 35.4229 9.45302 26.3798 5.18698 20.1527 -7.56493 +3231 6 45.3037 24.2791 20.2723 9.06075 11.2998 -13.4968 +3232 4 45.4523 24.978 19.6109 10.2075 -1.49386 4.95329 +3233 4 44.5125 23.8555 19.9662 -13.3892 -9.58217 -2.04663 +3234 6 15.8107 39.0453 24.2393 9.7405 19.086 8.48056 +3235 4 15.3407 39.8143 24.6455 3.07287 -17.6695 -6.90152 +3236 4 16.7434 39.3626 24.1878 -22.1708 -8.11019 0.25747 +3237 6 4.61074 25.9041 16.8066 4.47487 12.325 4.32837 +3238 4 5.33363 26.3313 17.2996 -1.16871 -8.95741 -3.63592 +3239 4 3.89121 26.5439 16.91 5.27726 -3.71411 -3.28281 +3240 6 33.4791 9.99232 32.5716 -36.5508 -4.76722 -31.2046 +3241 4 34.3147 10.2419 32.89 39.2476 10.968 21.6954 +3242 4 33.0188 9.57531 33.3002 0.324125 -5.12222 10.2577 +3243 6 22.9388 37.5185 1.51191 -4.27166 -24.2064 8.31852 +3244 4 23.0334 38.2273 2.154 1.20614 3.86272 6.71724 +3245 4 22.69 36.6978 2.02191 6.96614 23.4315 -10.5782 +3246 6 39.1324 20.5485 25.4772 25.265 -11.778 19.9951 +3247 4 39.2103 21.4279 25.1215 -1.526 12.0473 -3.88318 +3248 4 39.8813 20.4818 26.1301 -17.748 -0.0581828 -14.4699 +3249 6 25.0622 25.0762 37.6014 21.4558 5.76047 -13.7935 +3250 4 26.0349 25.2337 37.6294 -19.4467 -8.38624 -4.14531 +3251 4 24.8891 24.8197 38.5048 -7.65564 -1.94532 12.2316 +3252 6 12.209 35.7591 11.4203 -9.12536 1.25056 -5.53999 +3253 4 11.4995 36.2015 10.8899 19.2305 -11.6187 8.3526 +3254 4 12.8486 35.4161 10.7797 -5.71729 7.89629 -2.43108 +3255 6 42.046 15.7235 20.1276 29.9467 5.46844 -26.2367 +3256 4 42.5818 15.5034 19.3148 -14.0105 1.75231 17.5608 +3257 4 42.3615 16.6209 20.337 -4.0808 -2.27778 2.90042 +3258 6 53.2021 25.4307 39.5282 4.69599 -13.2561 7.07883 +3259 4 53.78 25.8541 38.905 5.49131 5.5629 -6.42231 +3260 4 52.4802 26.028 39.6966 -10.1139 9.50655 0.821399 +3261 6 53.7967 21.778 1.29815 15.5744 -8.20383 1.43914 +3262 4 54.6378 21.4326 0.944441 -3.84265 -1.46767 8.18122 +3263 4 53.3536 22.1543 0.542634 -13.037 9.31425 -11.6048 +3264 6 1.93111 22.4438 20.1768 4.00387 4.12813 31.1185 +3265 4 1.5939 23.2361 20.6593 2.49828 -13.4199 -15.2591 +3266 4 2.41139 21.9607 20.8911 -6.34657 6.89732 -14.8434 +3267 6 41.1871 16.1847 11.4932 0.836017 42.0531 1.99799 +3268 4 40.9413 15.3195 11.802 -9.8633 -17.6073 7.87469 +3269 4 40.5377 16.8617 11.8588 16.4331 -27.7799 -8.96912 +3270 6 17.194 38.6096 9.61825 4.75854 -2.20459 -16.4638 +3271 4 17.8324 38.6167 10.328 10.0816 -0.610832 12.429 +3272 4 16.3385 38.6013 10.0398 -14.9506 0.593169 11.9887 +3273 6 33.2005 12.9606 38.531 8.50507 10.8774 -15.8661 +3274 4 33.6532 13.8203 38.39 -7.98235 -13.7359 5.26797 +3275 4 33.1331 12.8007 39.479 5.11874 5.24255 -4.23095 +3276 6 24.7171 21.675 39.9778 2.8762 -23.2501 -10.2076 +3277 4 24.5558 21.597 39.0096 0.45736 0.189324 11.8412 +3278 4 25.3262 20.9394 40.2143 -5.83632 9.86919 -3.30671 +3279 6 13.5803 15.5602 27.3532 26.1047 30.3564 11.1382 +3280 4 13.1676 16.145 28.014 -3.26959 -8.19558 -5.9347 +3281 4 12.973 14.8589 27.1951 -20.4184 -17.1677 1.43072 +3282 6 24.68 18.7128 9.26691 14.3839 36.3501 26.0009 +3283 4 25.3598 19.2552 8.82532 -5.31062 -15.6251 -9.27674 +3284 4 24.5166 19.2286 10.0937 -4.12977 -20.8661 -14.1648 +3285 6 10.971 8.2031 0.0820528 -5.05885 27.6393 52.7366 +3286 4 10.426 8.82187 0.676738 20.6953 -23.692 -21.2054 +3287 4 11.8511 8.19112 0.51746 -10.8092 -0.715691 -8.01276 +3288 6 15.7168 31.9426 31.3882 -16.0589 -14.8784 11.374 +3289 4 14.8784 32.0139 30.9212 -5.19427 4.39929 -5.1125 +3290 4 16.2361 32.7208 31.1626 4.51908 -4.85975 -1.07492 +3291 6 20.3853 39.1678 21.6201 3.96912 1.70678 -2.15463 +3292 4 19.8408 38.4031 21.9136 18.3946 15.2484 5.21077 +3293 4 21.1259 39.3411 22.2478 -18.5683 -14.4588 -3.61544 +3294 6 38.8575 19.5345 7.60357 -3.22682 7.2187 -10.7103 +3295 4 37.9955 19.1157 7.58645 -3.56529 1.50397 -1.646 +3296 4 39.2183 19.2349 8.43232 7.58358 -7.76078 7.45775 +3297 6 41.3566 29.7161 21.1634 -18.4754 -13.1658 17.2704 +3298 4 41.7904 29.7702 20.3348 3.95998 3.00501 -30.3792 +3299 4 42.0386 30.0045 21.7486 9.4821 7.67994 22.7786 +3300 6 50.7055 33.8359 22.0677 10.0235 -14.5617 12.8511 +3301 4 51.0634 32.983 22.4061 -4.7136 19.0099 -8.42991 +3302 4 50.4062 33.6539 21.1646 0.0172424 0.211956 1.78818 +3303 6 18.1576 11.1602 14.3564 -14.1594 -3.53412 4.86119 +3304 4 18.0624 11.3441 15.3149 3.69196 -2.83217 -14.991 +3305 4 19.1071 11.0831 14.1997 2.21718 -0.861887 0.62752 +3306 6 48.509 14.2737 15.2536 -33.8512 -15.7039 -13.3543 +3307 4 49.4102 14.4821 15.4142 31.3042 4.03673 3.1002 +3308 4 48.4635 13.5769 14.5611 0.497508 10.2707 10.4073 +3309 6 32.9892 15.7452 8.24788 15.5762 1.59093 3.47394 +3310 4 33.8184 15.532 7.78513 -5.99942 0.288096 4.45585 +3311 4 33.1922 15.7362 9.20789 -3.05234 -0.622843 -13.6288 +3312 6 42.9176 4.85532 18.7629 14.1748 1.41964 3.40057 +3313 4 42.9882 5.82921 18.9229 4.77982 -22.1758 1.39114 +3314 4 43.8043 4.45344 18.9624 -18.3785 17.0247 -7.93082 +3315 6 10.5031 23.7237 33.4382 -0.874073 19.9298 2.74355 +3316 4 10.5548 24.717 33.3795 7.7257 -28.8706 -7.54496 +3317 4 11.1379 23.281 32.8547 0.735263 11.3428 1.89897 +3318 6 1.13216 20.0583 11.2836 18.374 17.5884 12.1148 +3319 4 0.491024 19.3349 11.1994 -2.17247 3.20995 10.4498 +3320 4 1.13554 20.5377 12.169 -13.4236 -25.5013 -29.3002 +3321 6 1.52072 39.5358 14.3069 -1.86369 -19.4721 11.7014 +3322 4 0.846705 40.1803 14.5938 4.14733 -5.95668 -5.60613 +3323 4 1.29368 38.6598 14.724 6.32152 28.9753 -9.07681 +3324 6 8.31775 21.6111 14.1387 -15.017 -6.93379 31.3726 +3325 4 8.13664 21.1659 15.0266 4.22851 15.111 -30.7591 +3326 4 7.52757 21.5034 13.5919 -1.9589 1.09648 1.01763 +3327 6 7.16491 13.3069 38.2405 -3.91014 1.61314 -29.5843 +3328 4 6.63698 13.0539 37.4502 4.01765 -4.94514 23.7112 +3329 4 7.51249 14.1719 37.966 2.17516 -8.38294 10.659 +3330 6 46.6268 1.62726 18.6981 -5.20766 -2.9114 16.5849 +3331 4 47.5711 1.68468 18.9367 -9.38594 -0.162468 5.90612 +3332 4 46.1191 1.48652 19.5414 20.1897 3.23395 -16.531 +3333 6 4.07867 8.38347 14.797 30.0262 18.9917 2.43531 +3334 4 3.34187 8.3175 15.3794 -25.1937 -7.21885 10.0707 +3335 4 3.92422 7.81173 14.052 -7.87119 -13.0009 -15.9092 +3336 6 47.5843 36.535 17.848 27.4213 12.0237 5.93301 +3337 4 47.2301 35.69 17.6416 -25.9655 -28.1947 -7.00186 +3338 4 48.5203 36.321 17.8356 11.6458 7.4707 2.49139 +3339 6 48.7172 32.6081 3.62434 16.9155 19.6851 -27.3563 +3340 4 49.4676 32.1613 3.18145 -8.8052 -0.0369675 17.0972 +3341 4 48.3534 32.1141 4.33579 -5.12692 -24.8974 22.5299 +3342 6 26.8624 34.4063 15.194 -5.61502 8.38998 -0.355377 +3343 4 27.128 33.6719 15.7603 3.91671 -4.37186 -8.54489 +3344 4 27.3784 34.3384 14.3661 -3.09932 -5.4603 13.6569 +3345 6 9.98983 27.3411 13.3236 -5.30345 -60.6937 -19.0037 +3346 4 9.94192 28.2179 13.0053 -1.51785 37.2293 -13.4128 +3347 4 9.87191 26.7487 12.5139 4.66007 24.2176 27.9858 +3348 6 2.39898 26.8872 37.357 1.59401 -7.29113 19.9813 +3349 4 2.39832 26.7504 38.3162 -5.28205 -0.510768 -0.23331 +3350 4 3.33711 26.9514 37.1904 14.8183 3.44774 -11.9786 +3351 6 33.3368 17.2756 36.8005 -23.2882 7.84328 1.94786 +3352 4 32.371 17.4043 36.8526 5.24602 0.476467 11.7287 +3353 4 33.4423 17.1515 35.8622 12.5187 -3.29866 -15.2334 +3354 6 10.6624 18.8035 9.30575 -3.98781 15.2275 -14.7508 +3355 4 10.7339 18.764 8.32616 -2.59554 -5.92059 15.2764 +3356 4 10.8972 19.732 9.49452 -1.55193 -6.4517 3.37647 +3357 6 8.57833 27.4047 3.14019 -5.09403 -6.13324 -2.85576 +3358 4 8.57126 27.6547 4.08504 -2.7611 -8.03155 -6.83353 +3359 4 8.4622 26.4231 3.09919 3.19624 23.0742 12.9307 +3360 6 40.6073 33.9264 14.3399 -6.85038 20.2562 -23.9123 +3361 4 40.863 33.245 14.948 0.807967 -8.16399 15.1571 +3362 4 40.0779 34.5716 14.8204 -0.495244 -4.69725 4.10141 +3363 6 53.9925 16.7992 13.6308 6.31935 -7.9338 28.1888 +3364 4 54.0997 17.1551 12.7528 -11.031 14.1585 -18.9596 +3365 4 53.1709 17.0486 14.0912 -3.14305 7.59696 -13.573 +3366 6 39.1497 38.4912 7.40608 -39.1223 4.05884 30.5073 +3367 4 38.8859 38.5922 6.48797 -2.00378 4.08479 -3.77896 +3368 4 38.3062 38.5986 7.97667 35.5804 -2.74434 -28.8566 +3369 6 42.2129 33.6808 29.0138 -24.1371 3.42921 -11.8129 +3370 4 42.1057 34.6378 28.7577 -2.98627 -25.8941 0.854821 +3371 4 41.3475 33.1819 28.8496 28.8118 27.0492 8.45917 +3372 6 2.85866 0.0629173 20.1315 -20.2536 1.52979 -19.4947 +3373 4 2.75203 0.421025 19.2221 8.85994 -2.20895 9.93397 +3374 4 1.96017 41.6124 20.299 15.6791 2.4666 6.01858 +3375 6 24.986 26.9373 24.4454 -5.13687 18.0728 7.96565 +3376 4 25.2851 26.0172 24.3926 4.88984 -3.86206 4.04103 +3377 4 25.2923 27.4081 25.2509 0.579281 -17.4573 -11.648 +3378 6 13.6179 33.9875 7.01366 -9.87556 12.4155 -39.0476 +3379 4 14.4287 33.6264 6.65472 5.99816 -4.92128 6.68342 +3380 4 13.2096 34.3429 6.17379 4.4552 -5.00021 31.0775 +3381 6 17.6494 31.8378 3.38868 3.47258 32.8259 -24.0658 +3382 4 17.3179 32.0585 2.49435 6.00696 -1.44586 18.975 +3383 4 17.3532 30.9566 3.5196 -11.0767 -31.773 11.9025 +3384 6 31.1111 29.8483 35.9167 13.6376 7.61418 -14.6842 +3385 4 30.4141 29.611 36.5018 -19.519 -6.65958 16.6428 +3386 4 31.8988 29.4329 36.2727 4.98993 0.410401 2.8928 +3387 6 31.4643 1.69164 1.93808 20.5111 47.6543 28.2436 +3388 4 30.8038 1.05919 1.86135 -35.916 -50.7273 -13.0106 +3389 4 30.9957 2.32106 2.5233 13.9145 -2.66096 -10.7861 +3390 6 13.7147 9.36591 12.3063 -10.8769 -31.3803 3.40225 +3391 4 14.006 10.2311 12.0687 5.19854 25.7457 4.3425 +3392 4 13.2135 9.34561 13.1466 7.78847 9.513 -6.56361 +3393 6 15.2882 15.1512 12.1315 -28.7349 -8.10496 1.75886 +3394 4 14.285 15.1274 12.2085 32.3197 -4.02875 -3.81405 +3395 4 15.5527 14.5676 11.4001 -6.69875 1.91641 1.76342 +3396 6 44.9132 30.4441 13.088 -39.1187 -0.31911 18.6923 +3397 4 45.3561 30.6438 13.8967 -2.95974 2.37903 28.1101 +3398 4 45.6316 30.4633 12.5179 38.3165 -3.24606 -51.9295 +3399 6 35.1465 37.623 24.8576 -14.1582 -15.7359 28.7413 +3400 4 34.5779 38.3725 25.1706 10.6028 -16.3472 -5.82963 +3401 4 34.9593 36.856 25.4995 5.71155 29.9045 -22.7235 +3402 6 43.8948 19.2936 12.9987 -2.30513 -18.2146 13.0469 +3403 4 43.787 18.3102 12.9069 2.76315 21.1578 4.09431 +3404 4 44.375 19.4187 13.8444 -6.58761 -4.34429 -6.9628 +3405 6 14.1971 27.3925 16.8971 2.69526 11.3314 -20.1154 +3406 4 13.4533 26.7979 16.9981 -2.42546 -10.6182 5.16389 +3407 4 14.0783 27.734 15.9851 5.1255 -3.8968 13.4589 +3408 6 5.08574 37.4729 15.7377 1.34169 3.72011 38.8669 +3409 4 5.88395 37.4897 16.2981 -4.65405 2.63162 7.63907 +3410 4 5.46406 37.2335 14.9215 11.9791 -13.9554 -41.5179 +3411 6 35.4862 36.9766 33.2333 -36.83 -5.70901 2.9599 +3412 4 36.4114 37.1444 33.1615 28.5824 10.2327 4.96708 +3413 4 35.1164 37.4942 33.9725 5.15458 -1.79752 -2.84758 +3414 6 6.636 31.7097 32.9848 -22.7133 -7.33235 -24.9389 +3415 4 7.22761 30.9741 32.8206 4.14198 -5.34147 5.16294 +3416 4 6.9999 32.2337 33.6789 14.5784 9.31919 13.8511 +3417 6 31.283 20.2175 25.4647 -9.91499 -1.61286 9.73388 +3418 4 30.5344 20.24 26.1037 18.6204 0.149313 -5.83605 +3419 4 30.8734 20.4846 24.6365 -0.167457 4.09649 -2.99843 +3420 6 54.9487 26.0868 7.35258 -28.6285 -0.216784 1.76255 +3421 4 54.2955 26.5615 6.794 6.74078 -5.97369 7.99882 +3422 4 54.4034 25.6757 8.0611 9.89476 6.61779 -10.5703 +3423 6 17.8651 35.1614 24.3791 -20.7499 -4.98646 -29.5673 +3424 4 18.0576 34.6235 25.1649 -8.37985 -1.7243 -11.1178 +3425 4 17.2007 34.681 23.779 26.831 10.1018 28.2803 +3426 6 49.1285 3.31358 19.7417 -8.45795 -3.91869 -17.1851 +3427 4 48.8119 4.11203 20.1653 -3.29153 9.9905 4.05996 +3428 4 49.7807 2.96094 20.3466 4.32541 -4.85853 3.16639 +3429 6 30.2844 35.6035 13.4934 7.2001 -0.317469 -2.452 +3430 4 29.4623 35.659 12.9857 1.71884 -1.71824 2.45729 +3431 4 30.0585 35.4328 14.4204 -4.00669 1.3983 -5.34585 +3432 6 43.3887 25.8808 41.6785 -22.9069 -12.3923 -2.55701 +3433 4 43.9997 25.6768 40.9817 12.0928 0.211006 -14.0269 +3434 4 43.8339 26.4255 0.397834 14.8568 14.8319 19.2759 +3435 6 21.0884 23.1529 6.38678 -1.35916 1.28851 13.8592 +3436 4 21.4 23.8645 6.98768 -5.78702 -12.5756 -9.70729 +3437 4 21.3246 23.4545 5.51028 2.40121 5.3387 -13.5131 +3438 6 54.6143 21.1989 19.0895 1.0726 18.3039 13.0104 +3439 4 0.43531 21.5582 19.5367 -15.0683 -8.68203 -12.1911 +3440 4 53.867 21.7044 19.4937 16.3508 -9.47613 -7.9193 +3441 6 13.877 38.9443 18.7624 -3.57764 -10.5141 -5.7706 +3442 4 13.4493 38.4672 19.4981 1.6116 7.10734 -3.21136 +3443 4 14.0821 39.8514 19.0249 -5.40993 2.00969 6.25434 +3444 6 39.1872 2.73234 39.6824 0.14108 0.727177 -8.14712 +3445 4 38.529 2.27328 40.2354 4.03816 -1.16808 -5.22543 +3446 4 39.0548 2.41866 38.7627 -6.48078 -0.982324 12.2661 +3447 6 43.2185 33.8148 8.84061 -19.4182 46.8926 -2.36482 +3448 4 43.1772 32.9719 9.24022 -1.50187 -35.3898 17.2737 +3449 4 42.5163 34.3616 9.29053 19.0727 -15.0644 -10.6104 +3450 6 23.089 16.6827 12.1027 15.7208 -3.2574 -7.89972 +3451 4 23.4385 16.1911 11.3228 -11.6069 8.24456 13.4993 +3452 4 22.136 16.8018 11.9813 0.424679 -1.38664 -3.29845 +3453 6 40.7855 26.1389 36.3196 -19.9126 19.309 9.87347 +3454 4 40.0986 26.8534 36.2514 19.4153 -21.5003 1.38126 +3455 4 41.1517 26.0031 35.4437 4.25962 0.995192 -8.54639 +3456 6 15.1503 11.6717 19.2973 0.724699 -1.19191 17.6918 +3457 4 15.5299 12.2877 18.6792 5.27756 8.7759 -18.41 +3458 4 15.4868 12.0294 20.1269 -4.65024 -4.08223 3.58338 +3459 6 9.86165 29.8154 31.387 -8.94942 -10.7424 5.06077 +3460 4 10.5846 30.1184 31.9716 0.245343 7.83947 -17.0155 +3461 4 9.856 30.1645 30.4637 12.8302 0.479173 21.4055 +3462 6 2.12473 30.035 25.2763 1.78753 8.3758 2.85176 +3463 4 2.08519 29.2167 25.7943 1.54705 3.16986 -12.4779 +3464 4 2.12365 29.8679 24.3136 0.147535 -6.31004 19.3474 +3465 6 49.0081 10.6471 7.05663 3.22839 15.7191 0.010386 +3466 4 49.8069 10.5015 7.59507 -11.7369 -5.9273 -2.35907 +3467 4 48.4474 9.86293 7.09337 3.15572 -10.0552 5.75386 +3468 6 38.6524 34.4248 32.4903 14.0617 12.8107 -4.97275 +3469 4 38.3124 35.2999 32.7524 2.4491 -7.54743 -1.61947 +3470 4 38.3152 33.7696 33.1015 -5.90625 -1.07654 6.02858 +3471 6 24.2925 24.7077 4.76791 -9.60212 12.423 13.627 +3472 4 24.6592 23.9059 5.14091 6.4374 -12.2494 -4.05598 +3473 4 24.0877 25.2629 5.55261 2.76703 -5.61196 -18.2913 +3474 6 44.0394 23.5955 33.7722 -22.1761 -10.7316 25.8053 +3475 4 43.54 23.0408 33.1405 14.8275 10.6039 0.934173 +3476 4 44.7909 24.0173 33.3845 18.136 8.68259 -21.6513 +3477 6 45.1404 31.9557 26.6336 7.63501 -16.8517 -19.5705 +3478 4 44.7419 32.078 27.4825 -5.98757 6.26965 19.5048 +3479 4 44.9572 31.0195 26.4087 0.928196 13.8489 4.22851 +3480 6 52.067 6.35346 22.8527 -23.4258 -19.9992 -0.226773 +3481 4 51.4359 5.65775 23.1792 22.6487 15.1416 -4.78776 +3482 4 51.473 7.11391 22.7826 5.97124 1.02094 -2.8274 +3483 6 5.11659 17.7141 30.4608 -43.6072 -14.7819 8.36724 +3484 4 5.56343 17.5578 29.6371 20.9412 3.52217 -11.7922 +3485 4 5.63141 18.2128 31.0754 22.7819 13.5036 5.79607 +3486 6 48.537 17.0137 6.52887 28.2349 12.1042 -25.3981 +3487 4 48.2628 16.1023 6.56372 -5.81913 -12.4107 2.5618 +3488 4 49.2494 17.0592 5.82246 -25.6562 2.24824 21.9849 +3489 6 13.808 31.3142 23.4689 -3.64011 -9.68131 26.3432 +3490 4 14.1349 31.2178 24.3617 -12.0329 4.75192 12.2102 +3491 4 14.6149 31.173 23.0226 30.8248 -5.26015 -34.1434 +3492 6 28.4946 33.4369 26.0285 16.4638 25.2333 -6.25798 +3493 4 28.7216 32.7387 25.4298 8.48672 -9.67688 -13.795 +3494 4 27.7897 33.0868 26.5316 -24.4903 -9.494 23.2581 +3495 6 9.0435 22.9594 11.008 21.162 0.605596 1.29652 +3496 4 9.33306 22.7779 10.1087 -4.82127 0.713158 -4.26872 +3497 4 9.8456 22.7632 11.5172 -9.5186 2.48902 2.0044 +3498 6 40.5545 4.06728 26.5809 44.6249 -53.7912 6.90123 +3499 4 40.0988 4.06982 27.4038 -17.0162 4.47424 24.8249 +3500 4 40.1579 4.71783 26.0744 -31.5116 46.4114 -32.7723 +3501 6 17.0554 37.9737 20.9489 23.2001 5.84937 -15.1211 +3502 4 17.8184 37.6206 21.4529 -18.1961 -0.773306 2.14347 +3503 4 16.241 37.9215 21.4323 -8.54619 -6.77157 16.0583 +3504 6 31.9589 6.36634 14.2007 -32.7312 -5.18635 1.31695 +3505 4 31.6173 5.45206 14.3159 2.63352 8.72785 -2.4018 +3506 4 32.9006 6.25378 14.1536 18.2531 -4.45925 -0.605861 +3507 6 29.3682 34.9487 39.6588 1.61784 2.82525 -17.5597 +3508 4 29.3689 34.7576 40.5935 -6.77547 -0.101859 12.4897 +3509 4 28.4273 35.0463 39.4168 8.43037 -3.37269 4.33216 +3510 6 22.5699 2.93494 32.1141 -1.63629 -8.86743 4.25418 +3511 4 23.0898 3.67063 31.7669 1.49018 1.71101 -1.29845 +3512 4 22.818 2.15292 31.5827 -1.92581 11.5593 5.09528 +3513 6 51.7444 19.0899 24.8018 18.5566 14.3159 27.8709 +3514 4 52.1262 19.3991 25.6728 -16.855 -8.06891 -29.5747 +3515 4 52.1578 19.634 24.1129 -3.61196 1.33098 2.20453 +3516 6 32.1137 13.664 24.2226 6.2567 1.72658 -37.8727 +3517 4 32.2307 13.7857 25.1378 6.97488 6.10606 45.7276 +3518 4 31.1794 13.5551 24.0935 -22.8325 -3.39176 -1.92521 +3519 6 9.48788 30.1788 28.8037 -7.90151 -0.480281 -10.0021 +3520 4 9.04214 29.3907 28.4657 0.296662 -4.58444 4.12418 +3521 4 9.71381 30.648 27.9899 1.85323 2.91474 4.33114 +3522 6 31.3027 3.12343 24.087 3.70677 4.08208 -3.18372 +3523 4 30.8363 3.94541 23.9161 -7.21645 -1.79011 2.75115 +3524 4 32.1629 3.26377 23.6687 3.35255 -5.74571 3.4439 +3525 6 2.14326 19.8385 36.4613 43.5578 -10.0216 -16.9659 +3526 4 3.05142 19.7594 36.0352 -31.8637 8.98539 19.2185 +3527 4 1.69253 19.0555 36.1346 -14.6763 0.545221 1.96285 +3528 6 36.957 16.7591 14.0918 2.96563 -13.2358 -6.51153 +3529 4 37.0513 17.1687 14.9682 1.23982 -3.45998 -2.6752 +3530 4 37.3406 15.8552 14.1067 -4.20166 12.9403 2.86695 +3531 6 1.82327 11.1921 6.0808 -0.275886 9.47834 -4.04825 +3532 4 1.66503 10.3513 6.51275 0.636708 -7.94921 -0.277572 +3533 4 1.41092 11.8149 6.68093 -3.53423 6.76721 2.7814 +3534 6 43.1526 36.8455 25.2619 -8.14588 -11.3328 3.19442 +3535 4 42.3648 36.774 24.6888 4.17675 -0.750929 11.0286 +3536 4 43.0263 36.2034 25.9927 3.18182 11.8936 -13.2388 +3537 6 32.1279 5.54767 7.01242 2.49094 2.37791 -5.83138 +3538 4 31.9279 4.68363 7.38152 0.218816 -4.41428 4.71371 +3539 4 31.563 6.18782 7.45455 -6.02642 2.24751 5.27561 +3540 6 15.066 21.4965 41.5173 26.6113 -14.2353 0.879596 +3541 4 14.4098 21.4318 0.299313 -13.8163 5.2854 1.00244 +3542 4 14.7314 21.9782 40.7628 -14.3918 6.6959 -6.38566 +3543 6 37.0263 36.0654 5.67599 -8.66989 11.0394 5.08886 +3544 4 36.7926 36.9074 5.26668 1.42879 3.21556 -9.50708 +3545 4 36.6993 36.1724 6.58455 6.67811 -8.44617 -2.15326 +3546 6 39.6264 22.8802 0.345968 -6.61229 0.0560669 1.87747 +3547 4 39.9979 23.7083 41.9266 1.97423 1.58642 1.0556 +3548 4 39.8106 22.8717 1.30105 -0.716498 -2.72173 1.5866 +3549 6 18.4762 23.1875 5.24196 -3.43754 -16.0644 -0.1002 +3550 4 18.2109 24.0785 4.97873 9.26343 12.8459 2.1419 +3551 4 19.3202 23.1705 5.73113 -5.23082 11.7415 -3.58503 +3552 6 34.4866 26.3931 0.410981 -26.1443 -19.9516 50.1306 +3553 4 33.9706 27.0567 0.94736 13.8106 -10.3269 -20.7381 +3554 4 34.4077 25.5868 1.01915 10.7474 25.1704 -28.4611 +3555 6 28.1474 26.0925 40.6196 -28.5345 -18.6936 36.4955 +3556 4 29.0529 26.0026 40.9247 9.18224 2.32741 -2.79367 +3557 4 27.6107 25.644 41.3519 15.6172 17.8969 -31.6189 +3558 6 41.7482 4.39863 30.2421 -5.41295 4.8086 27.4354 +3559 4 42.5847 3.93131 30.2216 8.80522 -6.59194 -7.61494 +3560 4 41.6924 4.68152 31.1831 -5.94926 -0.146025 -12.4776 +3561 6 4.45598 8.30655 29.1222 20.5127 -16.5965 8.52389 +3562 4 3.66946 8.7156 28.7677 -9.60933 13.4518 -0.978151 +3563 4 4.96147 8.97819 29.6123 -10.8114 0.933443 -7.64816 +3564 6 12.9096 9.61234 32.1411 7.95239 -11.3181 7.67023 +3565 4 12.5174 8.82681 31.7782 -9.40951 -4.97415 -8.25208 +3566 4 13.381 9.26623 32.9076 3.83436 11.6436 3.42456 +3567 6 48.6608 16.2478 1.44826 -41.5847 5.12436 -2.24268 +3568 4 49.5977 16.2655 1.51923 27.6715 2.95254 13.2549 +3569 4 48.2356 16.5221 2.2956 18.9339 -8.30142 -14.6437 +3570 6 26.4307 40.0076 21.1903 -9.81311 41.2665 6.04236 +3571 4 27.1749 40.6498 21.1967 -8.04845 -12.0635 0.822588 +3572 4 26.7755 39.1508 21.0026 13.0624 -20.4442 -2.17563 +3573 6 35.79 4.08177 9.00682 -31.6066 0.334495 -4.41207 +3574 4 35.483 4.74976 8.36033 1.0784 -4.66377 5.72074 +3575 4 35.0087 3.86601 9.59196 22.2264 5.21899 -16.6494 +3576 6 52.6895 3.55332 27.8634 16.2443 -8.90238 -17.7273 +3577 4 53.4861 3.5089 28.4695 -19.2533 -5.0216 -23.8454 +3578 4 52.9436 3.34738 26.8904 -3.28408 11.0051 45.9059 +3579 6 48.3169 26.6974 27.3926 25.9077 -23.6746 5.28014 +3580 4 49.0048 25.9927 27.5456 -25.7263 19.495 -6.18754 +3581 4 48.6886 27.4598 27.8411 -2.12981 11.4596 4.51315 +3582 6 24.5097 4.95686 18.7286 -11.1396 -9.34012 13.2359 +3583 4 24.0942 4.18073 19.1756 8.31772 16.1923 -9.35863 +3584 4 23.9484 5.73893 18.8892 6.66511 -10.1227 -0.689949 +3585 6 24.0567 12.4804 28.7686 -1.83015 0.889486 -1.95598 +3586 4 23.1997 12.8888 28.9043 -2.54864 9.49841 4.61676 +3587 4 23.8244 11.6446 28.3683 7.90245 -6.62953 -5.67748 +3588 6 40.1561 27.7426 40.8073 -21.5317 7.14576 -7.35733 +3589 4 40.4932 26.962 41.2601 -12.917 0.0491148 -0.726507 +3590 4 39.1936 27.5721 40.6401 25.9681 1.33069 1.19471 +3591 6 11.9274 13.5458 26.9496 -4.40765 -1.96337 -6.60028 +3592 4 10.9986 13.6678 27.167 -4.51497 -1.32563 0.190923 +3593 4 12.2404 12.8654 27.5442 6.31176 -11.0874 3.59056 +3594 6 52.1902 29.5387 41.394 18.594 -11.3781 3.59259 +3595 4 51.989 30.3087 0.0068425 -9.85392 15.5397 4.91192 +3596 4 53.1003 29.3208 41.6912 -5.64389 -6.04423 -8.59676 +3597 6 17.4867 19.0227 39.1838 -6.27455 21.666 2.75279 +3598 4 17.488 19.586 40.0024 0.860103 -14.9947 -21.9977 +3599 4 17.2876 19.5951 38.4014 5.36511 -12.0476 21.2649 +3600 6 46.2283 27.6807 33.7144 -6.74129 13.676 11.5468 +3601 4 46.0876 28.3582 33.0447 4.86435 -1.49715 -10.0026 +3602 4 45.6533 27.9743 34.4365 0.457797 -3.70748 6.99028 +3603 6 35.8353 29.5439 5.61992 2.49906 -1.59566 -19.7219 +3604 4 35.6527 29.5233 4.66367 4.90114 -0.621078 3.19465 +3605 4 35.4473 30.3766 5.88547 -3.82587 11.7884 10.6864 +3606 6 47.2822 25.7798 30.1513 -10.5766 8.53329 -17.9568 +3607 4 48.1664 25.813 29.7363 -13.2628 3.84456 1.19765 +3608 4 46.6616 26.387 29.6551 21.0058 -12.1546 6.47151 +3609 6 51.3953 12.3638 20.0228 -1.62023 8.46277 -4.73872 +3610 4 50.7529 12.7462 19.4094 4.65296 3.97806 -1.37635 +3611 4 50.8736 11.6867 20.4477 2.10356 -10.8225 11.04 +3612 6 41.9857 18.3757 28.9464 12.9674 -8.39178 -20.9845 +3613 4 42.6678 18.0249 28.3214 -8.5661 8.58724 12.8041 +3614 4 42.4509 18.9846 29.5329 1.95722 -2.13958 -2.01301 +3615 6 53.5955 6.47736 7.49747 -17.4879 -34.0434 -11.6994 +3616 4 53.215 5.56736 7.34717 12.2612 27.0176 1.32153 +3617 4 53.8473 6.47025 8.42428 8.27981 0.813073 3.28926 +3618 6 9.90701 10.6092 26.7593 2.25524 -7.80823 -0.160956 +3619 4 10.2937 10.2906 27.6083 -8.74192 13.2514 -11.8083 +3620 4 9.6719 11.5504 26.8324 5.3909 -8.28719 7.73453 +3621 6 9.32838 39.4044 29.7661 28.1478 19.087 17.9947 +3622 4 10.1636 39.3682 30.3277 -29.6144 2.71186 -18.0569 +3623 4 8.79772 40.1574 30.1092 9.7156 -13.1012 -9.05156 +3624 6 33.3969 4.77935 0.0338577 7.04977 -8.48101 -1.75146 +3625 4 33.7652 5.5373 41.4968 -3.54645 16.0087 -2.35532 +3626 4 34.1271 4.15493 41.8774 -6.76144 -3.49152 6.70786 +3627 6 35.7118 10.6691 34.2465 30.5451 -20.2214 -10.6481 +3628 4 35.199 10.7815 35.0349 -14.696 6.44481 20.012 +3629 4 36.4515 10.0721 34.5187 -16.7263 14.6249 -6.06398 +3630 6 15.1941 17.3851 19.1797 2.70911 -28.1342 -44 +3631 4 15.4897 16.9339 18.3047 -12.3876 19.7973 41.7399 +3632 4 14.2542 17.5546 19.0074 0.407714 2.19657 2.29796 +3633 6 17.478 37.6645 15.4329 -18.9254 1.45878 17.8737 +3634 4 16.9549 37.8023 16.2867 26.4617 -7.60783 -22.0624 +3635 4 18.4074 37.4659 15.6333 -6.79317 3.25497 7.31584 +3636 6 26.2497 8.20945 21.7084 13.406 8.66037 11.1677 +3637 4 26.4123 8.51714 22.643 -13.4745 -7.28424 -22.9055 +3638 4 25.3027 8.1176 21.5293 -5.49097 3.27453 10.4234 +3639 6 0.34 9.90937 15.4047 -28.932 15.8312 -5.67551 +3640 4 1.21626 9.57115 15.2747 8.47529 -16.8828 -5.88536 +3641 4 54.6903 9.41637 14.8207 22.8064 6.49071 10.4803 +3642 6 13.4564 40.6532 9.29599 -22.1307 -5.15585 -0.326819 +3643 4 12.4714 40.4452 9.30279 34.033 7.20134 3.90171 +3644 4 13.9359 39.9749 9.79874 -9.44555 -0.536228 -2.64909 +3645 6 49.5525 25.9167 33.0087 8.30289 -20.978 36.7812 +3646 4 50.1102 25.581 33.7998 -31.2394 16.5759 -41.6702 +3647 4 48.6381 25.5592 33.0807 18.1841 3.33668 -0.378289 +3648 6 37.0921 40.0433 26.4323 -69.9693 32.9093 31.9949 +3649 4 36.1848 39.6472 26.7001 50.2617 0.87061 -16.3943 +3650 4 36.887 40.9984 26.66 23.4133 -30.5831 -16.8038 +3651 6 47.9876 17.8592 12.1588 -8.21233 14.3088 -32.1086 +3652 4 47.5845 18.6288 11.6747 8.44083 -19.6159 16.8154 +3653 4 47.7143 17.8826 13.0665 -7.39134 3.08395 19.3289 +3654 6 27.9663 29.0642 34.1603 1.53587 -18.0299 -1.74725 +3655 4 28.882 28.804 34.3498 -7.37789 1.41773 -2.30399 +3656 4 27.9529 30.0159 34.1809 1.22694 21.8088 1.61581 +3657 6 34.0029 2.78452 13.2168 -24.1529 16.185 8.10865 +3658 4 33.6393 2.32953 13.9926 -4.91269 2.52718 -2.68734 +3659 4 34.7844 2.29731 13.0428 30.2788 -14.7346 -8.06408 +3660 6 28.44 36.053 11.4482 -19.9886 -0.916941 20.5685 +3661 4 28.0041 35.3416 10.9605 0.296796 1.69001 -2.92558 +3662 4 29.0597 36.4216 10.8465 18.9417 8.99323 -20.1084 +3663 6 36.1834 11.364 28.8528 2.80179 -1.8504 -16.6465 +3664 4 35.2026 11.3648 28.9433 17.0081 -1.44193 -10.527 +3665 4 36.4266 11.2403 27.8881 -16.5332 2.0664 24.3605 +3666 6 24.8155 39.488 16.899 1.95651 8.69094 -17.2938 +3667 4 24.2729 40.277 17.0547 2.68209 -2.76325 7.28198 +3668 4 24.7648 39.3887 15.9322 -0.898649 -0.731043 6.96785 +3669 6 49.9432 8.0514 22.8505 -60.8038 -24.1516 -13.0827 +3670 4 49.7668 7.94962 23.7845 10.2147 3.57848 16.1239 +3671 4 49.0378 7.75433 22.5026 41.2245 11.1916 1.13457 +3672 6 52.0935 19.338 10.2277 12.6357 -4.19253 18.0692 +3673 4 51.6063 19.2592 9.39778 1.74616 10.4418 -3.52762 +3674 4 52.4735 20.2434 10.294 -12.5007 -15.5081 -12.5544 +3675 6 24.8386 15.8838 6.12895 -18.3448 14.0073 -0.236232 +3676 4 24.2024 16.3229 6.74681 14.2411 -11.6767 -8.77744 +3677 4 24.4989 16.1625 5.25788 7.11766 -3.93298 6.13727 +3678 6 49.3148 23.6851 8.6303 24.9689 -39.379 16.691 +3679 4 49.2746 22.9584 9.31909 -7.63259 29.9964 -23.4819 +3680 4 48.4638 24.0489 8.3953 -15.5352 0.433996 3.53825 +3681 6 0.208059 10.6481 32.1797 22.1875 -2.28391 4.69689 +3682 4 1.08388 10.2912 32.3483 11.827 -2.86298 -20.6213 +3683 4 54.878 10.581 33.0649 -30.4469 3.74284 18.7822 +3684 6 12.5874 32.9143 13.2407 -35.4131 4.94433 4.95913 +3685 4 11.7345 33.4182 13.1185 22.1299 -14.9844 2.19911 +3686 4 13.2795 33.4792 12.9271 13.1216 10.0242 -5.44208 +3687 6 21.734 32.5657 14.1089 -30.2641 -10.609 17.8788 +3688 4 21.1735 33.3586 14.1938 13.4775 0.171544 -7.80997 +3689 4 21.2373 31.9121 14.6504 18.4585 12.3126 -12.4653 +3690 6 48.1656 34.8484 27.3207 -34.4178 -12.3509 -32.6658 +3691 4 47.5287 35.1179 27.9926 9.598 2.53078 9.45385 +3692 4 47.5616 34.4813 26.6056 29.2581 12.2879 19.461 +3693 6 45.6153 31.2627 36.0943 -37.261 16.4569 21.0579 +3694 4 45.7916 31.8927 35.3904 -0.807743 4.61331 -8.81752 +3695 4 44.8366 31.6277 36.6156 19.759 -7.25665 -17.1647 +3696 6 46.2873 0.296503 14.3622 0.346279 -8.22198 0.0964187 +3697 4 46.2502 1.23933 14.2464 -13.6881 13.1616 4.37405 +3698 4 47.2018 42.0236 14.1712 14.709 -12.2876 -2.23521 +3699 6 14.3299 18.994 40.2006 -30.7379 -32.6603 -9.06287 +3700 4 14.4791 19.2338 39.2972 7.93482 8.11578 -14.4624 +3701 4 14.6855 19.6458 40.7662 17.9566 28.0241 18.1173 +3702 6 14.5596 1.14026 10.2341 26.3279 -2.23148 -9.5451 +3703 4 15.4055 1.22344 9.73443 -17.3894 7.51472 10.761 +3704 4 14.1379 0.381418 9.8097 -7.55267 -3.97863 3.86231 +3705 6 34.4334 40.9199 12.9894 -0.940803 4.29697 -17.7271 +3706 4 34.039 40.5607 12.1545 5.82782 2.6847 22.9711 +3707 4 34.273 40.3011 13.7266 -2.01031 0.481385 -16.696 +3708 6 42.1477 25.6267 33.9881 24.0417 -24.4569 -2.75436 +3709 4 41.6299 25.3559 33.2134 -0.0206438 0.202706 6.41118 +3710 4 42.855 24.9213 34.0976 -22.0628 21.5276 -5.85955 +3711 6 29.1852 22.5895 40.0737 -4.6165 -6.65381 -10.571 +3712 4 28.5947 23.1672 39.581 -0.582997 4.41945 3.85107 +3713 4 29.0675 22.7332 41.0074 -2.93269 3.94269 10.2267 +3714 6 44.8062 18.6252 1.49818 5.72139 3.58279 15.6322 +3715 4 44.9314 18.8801 2.44529 -3.9019 -2.65234 -18.9387 +3716 4 44.0985 19.1782 1.14518 3.29812 2.13948 3.69359 +3717 6 4.47265 10.8135 23.9407 -24.2902 -18.4562 11.3409 +3718 4 5.11906 11.4142 23.6391 22.3407 21.5355 -19.7447 +3719 4 4.51291 10.8829 24.8932 -6.80118 0.381125 6.4492 +3720 6 6.46087 23.0097 28.9948 -0.180046 29.3158 3.74757 +3721 4 7.16357 23.1777 29.6697 -12.977 -15.1924 -17.9731 +3722 4 6.42476 22.0762 28.8013 7.623 -17.0728 6.50296 +3723 6 39.796 25.1427 32.5747 9.70804 -1.04373 -32.2987 +3724 4 39.5377 25.4516 33.4106 -12.9416 11.3784 38.6909 +3725 4 39.6539 25.9218 32.0211 1.09764 -5.16827 -8.54386 +3726 6 40.8629 21.4836 8.86543 0.741147 13.6451 -7.24725 +3727 4 40.6441 21.3431 7.92826 2.29745 -6.5969 8.98303 +3728 4 41.3236 20.7041 9.20266 3.81714 -8.25026 -3.81722 +3729 6 0.635293 1.4289 12.9408 -11.8573 10.3167 -17.0811 +3730 4 54.7874 1.76314 12.6159 9.08744 8.74788 -10.2417 +3731 4 0.270536 0.805051 13.547 10.8795 -21.9384 23.5147 +3732 6 32.6734 29.7199 23.4842 -6.31159 -22.9731 3.95312 +3733 4 32.3164 28.805 23.472 7.37478 14.3791 4.20759 +3734 4 32.5291 29.9779 22.5736 0.738758 10.2783 -10.1223 +3735 6 12.5322 37.1564 20.4866 30.6876 51.3804 29.6269 +3736 4 13.0449 37.1468 21.3313 -10.4644 -1.04639 -16.0138 +3737 4 12.1935 36.3015 20.3752 -17.5174 -49.5479 -6.43685 +3738 6 13.879 14.5208 24.6979 -2.0089 -0.488943 14.0828 +3739 4 13.5126 15.2415 24.1863 -2.86121 7.01781 -5.24136 +3740 4 14.0435 14.8889 25.5812 -0.885703 0.504049 -6.33424 +3741 6 17.5084 27.0547 26.4789 25.7109 3.2743 -38.4356 +3742 4 17.3703 27.9297 26.0618 -4.07905 -12.769 13.7294 +3743 4 18.1097 26.6273 25.8042 -17.4354 5.34049 24.3014 +3744 6 54.4807 9.52867 26.3526 -8.08409 11.5192 21.059 +3745 4 54.0543 10.3952 26.5681 7.59002 -15.9534 -5.94965 +3746 4 54.8701 9.18952 27.1901 -5.85154 7.09102 -14.0848 +3747 6 33.6811 21.5047 24.9231 9.13792 -2.03882 -43.3211 +3748 4 33.6373 21.3676 23.9235 3.71376 4.25849 32.7793 +3749 4 32.846 21.1613 25.2346 -13.4677 -6.75943 10.2286 +3750 6 22.147 35.267 2.89295 -1.50127 3.24452 17.3348 +3751 4 22.2381 34.4 2.47628 0.948748 -2.82555 0.0189077 +3752 4 22.0999 35.1233 3.8735 0.523717 -2.91888 -18.7193 +3753 6 45.3111 5.3951 15.6139 -0.0233827 -18.9082 29.3701 +3754 4 45.1442 5.22798 16.5663 9.63366 2.6406 -14.7931 +3755 4 44.5125 5.84005 15.3428 -8.81534 4.22624 -14.6387 +3756 6 5.67663 7.59044 16.9735 -0.040306 4.08799 -12.5895 +3757 4 5.28026 7.88599 16.128 7.47401 -1.2917 10.5251 +3758 4 6.58383 7.937 17.01 -0.793937 -3.87211 -2.68331 +3759 6 34.58 39.0977 27.2045 1.42769 14.436 -3.31523 +3760 4 34.2907 38.4975 27.863 -0.77861 -26.0942 16.6839 +3761 4 34.0642 39.8725 27.4397 -1.42861 13.6713 -5.6929 +3762 6 32.7657 33.6085 34.293 -22.4583 20.5671 -18.6673 +3763 4 32.1806 34.0441 33.6111 23.9751 -17.2665 15.818 +3764 4 32.4638 34.0082 35.1245 2.30326 -6.42306 -1.86009 +3765 6 30.988 41.2133 32.384 -4.02481 -7.82035 -3.95856 +3766 4 30.2267 41.2202 32.9774 -4.32902 6.50081 -0.328838 +3767 4 31.0509 0.17511 32 -1.2051 10.1503 -2.92525 +3768 6 7.6493 1.59177 27.1464 22.3535 -22.6118 -16.4669 +3769 4 8.41104 1.29664 26.5499 -29.8997 15.2665 16.3611 +3770 4 7.54328 2.53873 27.061 4.65755 9.49162 -4.22239 +3771 6 0.888965 22.101 37.8501 15.4112 -23.8094 -16.9331 +3772 4 1.26739 21.3109 37.3638 -11.0686 24.0488 15.8162 +3773 4 1.18 22.8712 37.3372 -1.61814 -2.27923 2.93708 +3774 6 7.39632 11.121 19.2332 -2.86932 4.41375 3.62624 +3775 4 7.58751 12.0436 19.3904 -7.23274 18.3647 6.41875 +3776 4 8.29083 10.7877 19.1848 5.97481 -12.1861 -3.76707 +3777 6 43.7816 12.5054 37.3126 2.86093 2.78929 -1.28281 +3778 4 43.9727 12.4749 36.3586 -3.06612 0.785718 5.83621 +3779 4 44.6572 12.6706 37.7021 -4.14278 -2.20963 -1.61523 +3780 6 29.0947 33.5132 36.1777 7.61955 17.1376 -26.1106 +3781 4 29.8261 34.0815 35.8667 -13.5031 -6.20718 4.51186 +3782 4 29.4784 33.1216 36.9462 10.9925 -12.9866 20.6523 +3783 6 14.807 4.60084 3.93512 20.0881 9.19657 -13.3363 +3784 4 14.316 4.04064 3.33426 -13.0632 -7.60853 1.79497 +3785 4 15.6236 4.79338 3.42413 -10.111 -0.253003 10.8348 +3786 6 39.0437 6.41097 6.40143 -11.952 4.4329 11.9095 +3787 4 39.4604 7.16771 6.02322 8.12547 27.0605 -0.357881 +3788 4 39.3566 5.75952 5.7919 -0.567413 -21.3616 -5.48613 +3789 6 22.2146 37.9992 40.767 -9.02066 -17.4896 -19.1754 +3790 4 22.494 38.8839 40.5618 6.85259 22.4587 -5.93601 +3791 4 22.4583 37.8811 41.6743 4.99519 -4.33654 23.0463 +3792 6 4.4524 23.286 6.15211 29.8095 -7.21279 -13.1375 +3793 4 3.81791 23.938 6.45512 -14.4589 -6.71938 9.72163 +3794 4 4.31449 22.3781 6.49744 -8.68344 13.1635 4.00749 +3795 6 12.4271 23.7748 9.24631 -1.26755 4.43152 21.3749 +3796 4 11.5607 23.6235 8.88266 -11.7175 -2.77193 -9.11925 +3797 4 12.2509 24.3149 10.0432 11.3809 -1.60307 -13.9136 +3798 6 46.4989 15.2625 16.9679 -12.8481 -2.49131 10.8408 +3799 4 47.085 14.9252 16.2779 8.49272 6.07271 -3.86524 +3800 4 46.8927 16.0486 17.3753 9.61298 -1.72862 -3.23202 +3801 6 34.1182 27.164 19.7815 17.9289 -11.392 6.58771 +3802 4 34.8637 26.5005 19.7508 -17.7467 14.3364 5.12367 +3803 4 34.0077 27.4664 20.702 3.31322 -6.80894 -12.4792 +3804 6 46.9518 13.2225 35.1059 11.5726 -0.299351 34.0182 +3805 4 47.3951 14.0533 34.9197 -1.30218 2.22738 -12.772 +3806 4 46.5273 12.8898 34.3328 -6.46075 0.0352155 -21.0879 +3807 6 50.5846 18.7905 12.5321 0.161349 -2.47544 -10.5355 +3808 4 49.7474 18.3698 12.2516 10.3296 3.30344 0.704295 +3809 4 51.1853 18.7954 11.7538 -11.6392 0.795373 7.80699 +3810 6 32.4849 12.6316 31.9547 13.623 -32.1984 -17.1952 +3811 4 32.7548 11.6805 31.9646 -3.77817 17.5545 -6.43374 +3812 4 32.3724 12.7906 32.8759 -7.39939 11.2146 27.5789 +3813 6 6.21204 19.6856 10.0139 6.84548 18.8235 13.1049 +3814 4 6.54027 20.2383 9.28123 0.761161 -1.37122 2.72757 +3815 4 6.08461 20.3138 10.7689 1.69871 -13.3343 -16.4193 +3816 6 21.5267 21.5372 2.4283 -5.72751 11.2346 -5.82425 +3817 4 21.7624 21.5115 1.48057 4.80944 -6.6677 9.03128 +3818 4 21.9699 20.8013 2.88237 1.68469 2.19074 -10.3234 +3819 6 38.389 23.0803 17.19 -15.8009 11.2489 14.8144 +3820 4 38.843 23.3405 16.3672 7.30113 -17.2523 7.40945 +3821 4 38.5581 22.1678 17.4979 8.57434 6.38113 -15.3203 +3822 6 29.7009 24.9705 22.2505 40.9979 -45.9373 -29.6811 +3823 4 30.2007 24.9541 23.0531 3.51493 7.58579 28.6285 +3824 4 28.9709 25.5198 22.3387 -45.941 40.092 17.1582 +3825 6 30.3026 21.4444 37.7784 -57.0222 17.1687 -23.3742 +3826 4 30.3615 21.3347 36.805 9.38026 -2.23221 21.4717 +3827 4 29.3011 21.6413 37.9016 49.3444 -12.8915 1.59191 +3828 6 11.8723 11.7062 16.3108 -33.4349 -15.0686 -41.1118 +3829 4 11.3207 12.2631 16.8681 -3.98396 2.02201 -1.40695 +3830 4 11.3108 11.5232 15.4705 24.8968 9.48818 41.0096 +3831 6 5.70652 16.9717 10.4705 4.17204 -12.2255 5.26049 +3832 4 4.89872 17.0293 11.0039 1.44556 1.21447 -8.81597 +3833 4 5.85075 17.8293 10.0626 -3.65007 4.58518 2.58079 +3834 6 41.6977 34.1692 35.8837 -2.16171 7.35997 35.3278 +3835 4 41.9434 35.0359 36.2767 -7.39108 -12.3774 -11.2945 +3836 4 41.6554 34.2509 34.9408 0.248654 6.88642 -24.6778 +3837 6 33.755 1.15956 30.1148 26.9661 -5.30311 0.785489 +3838 4 32.8327 1.41064 30.2749 5.35845 -2.81639 19.5818 +3839 4 34.3082 0.981132 30.9387 -30.8845 7.54253 -18.2089 +3840 6 50.3537 18.6141 36.9811 22.0078 18.2711 -1.17075 +3841 4 50.0553 18.9081 37.8421 -3.0234 4.11827 7.26126 +3842 4 49.7241 17.9789 36.6994 -26.7065 -28.1871 -12.5747 +3843 6 24.6713 24.2747 40.2422 -22.5478 13.5437 8.83718 +3844 4 23.7682 24.4281 40.6159 16.469 -5.34198 -8.29501 +3845 4 24.8078 23.3187 40.2616 -1.76472 2.5507 -0.358513 +3846 6 37.3089 22.0315 23.2412 -5.67505 16.6134 8.34505 +3847 4 36.9227 21.8066 24.1113 8.4343 -8.15598 -10.5545 +3848 4 37.8295 21.3076 22.8826 1.63944 -5.88141 4.04288 +3849 6 48.4175 40.505 28.9613 -8.44239 17.3351 -31.8351 +3850 4 48.9168 41.2502 28.5701 -3.67522 -6.90368 3.5913 +3851 4 47.6498 40.4225 28.3398 9.75729 -4.39015 14.633 +3852 6 24.8456 8.73476 16.5822 -4.20971 0.107082 12.7896 +3853 4 25.4166 9.33437 17.0882 0.801486 -3.84637 -6.6671 +3854 4 25.3552 7.93888 16.3774 1.47583 -1.66023 -1.71228 +3855 6 19.2415 22.9983 32.4591 18.0731 -7.21062 -7.32059 +3856 4 18.4972 23.4837 32.0941 -3.55414 -1.2008 3.19393 +3857 4 18.9283 22.447 33.1757 -6.31405 0.951806 3.86493 +3858 6 3.33315 21.6719 22.4471 -31.3651 -15.1442 10.7623 +3859 4 2.72119 22.0562 23.134 20.4737 -7.45649 -18.1084 +3860 4 4.09369 22.238 22.38 14.9219 12.7334 2.89238 +3861 6 10.2287 20.327 12.827 -13.2346 -13.5387 -5.73443 +3862 4 9.59835 20.9044 13.2794 3.30523 -1.6991 -3.3419 +3863 4 9.66163 19.6709 12.3619 8.96671 11.3846 7.22783 +3864 6 9.52445 0.665703 25.3447 51.6699 36.9138 -22.1471 +3865 4 10.407 0.70007 25.8038 -28.3091 -11.588 2.11711 +3866 4 9.73816 1.30323 24.5834 -23.5062 -26.9191 23.3279 +3867 6 10.6629 40.7098 9.64162 -13.7092 -10.0604 -17.7529 +3868 4 10.6663 41.3337 10.3633 -2.25222 9.44489 9.13119 +3869 4 9.9177 40.9644 9.04966 14.1089 -1.91013 12.7496 +3870 6 46.3583 25.2138 32.6818 -7.00173 28.401 24.5039 +3871 4 46.1658 26.0815 33.1748 9.63216 -40.3762 -24.4036 +3872 4 46.6683 25.4845 31.8081 -0.340565 -0.626762 -0.366217 +3873 6 38.9398 3.19835 23.1062 35.7507 -3.98021 4.80576 +3874 4 38.0789 3.42388 22.7807 -21.691 0.0477325 0.592254 +3875 4 38.9606 2.6551 23.9199 -14.9585 3.95725 -7.0779 +3876 6 33.3518 23.6324 36.8776 -10.909 11.1506 22.2396 +3877 4 32.7475 23.7189 37.6717 16.9933 -10.7727 -23.1962 +3878 4 33.5054 24.5617 36.6454 5.48307 -3.56245 -8.14833 +3879 6 51.9403 33.327 25.4307 18.0164 46.0043 -41.5452 +3880 4 51.481 33.1217 26.2288 -14.6019 -1.8433 25.1586 +3881 4 51.8744 34.3335 25.2555 2.07578 -44.1738 12.4077 +3882 6 32.1773 25.016 33.1611 -3.65323 12.5958 -4.40686 +3883 4 32.7417 25.8243 33.1248 -13.2213 -13.5953 2.20315 +3884 4 31.2567 25.3353 32.9959 15.6883 -4.24783 1.324 +3885 6 51.2804 27.7082 39.5058 -12.4055 -13.8576 13.4454 +3886 4 51.6333 27.8214 38.6405 7.56348 -1.28822 -27.9214 +3887 4 51.668 28.4332 39.9759 4.38661 13.1583 16.7532 +3888 6 34.2776 28.325 17.2612 18.5433 -9.6807 0.726105 +3889 4 33.4618 28.7621 17.0499 -21.6526 10.7978 2.5619 +3890 4 34.2928 28.1986 18.2187 -4.64072 -2.98555 4.57564 +3891 6 36.914 8.0422 37.8636 -11.4128 -16.3489 28.1347 +3892 4 37.1972 8.46051 37.0352 12.2245 9.0272 12.2411 +3893 4 37.2151 8.41454 38.7513 -7.64029 -1.69915 -40.4466 +3894 6 34.8876 19.4054 6.12727 15.6033 7.52257 2.15709 +3895 4 34.0531 18.9355 6.15655 -6.74313 -1.04378 -1.75599 +3896 4 34.6977 20.3552 6.00766 0.606543 -4.24654 -1.2187 +3897 6 52.9513 9.46866 7.83406 2.51792 52.5995 -46.1577 +3898 4 52.8182 10.1965 7.1313 21.8169 -33.4663 26.408 +3899 4 52.1097 9.49548 8.25498 -20.9439 -11.3984 23.93 +3900 6 36.2784 5.48477 38.9735 -18.6298 -4.41122 2.56352 +3901 4 36.9459 5.47799 39.6359 15.3203 -14.8264 18.8091 +3902 4 36.5882 6.23606 38.5023 -2.18903 24.2959 -30.3279 +3903 6 10.0091 14.4595 13.4727 4.14065 20.8003 14.1725 +3904 4 10.1735 15.3719 13.8184 -7.35802 -17.2864 -8.75733 +3905 4 9.20522 14.5177 12.9398 -1.57173 0.82324 -0.279823 +3906 6 17.2166 24.3595 39.7866 10.3316 -24.6644 9.74438 +3907 4 16.8461 25.2181 39.6219 -11.8102 15.8188 2.99696 +3908 4 16.9967 24.0978 40.7081 2.51259 6.67153 -9.86646 +3909 6 49.0842 32.5535 7.76087 3.66191 -12.3496 8.85055 +3910 4 48.2705 33.0417 7.89853 -4.87459 2.09702 3.01394 +3911 4 49.5463 32.9698 7.04629 8.35168 7.01386 -14.6239 +3912 6 44.8849 24.3899 5.46806 25.9844 8.68062 13.8603 +3913 4 44.662 24.5947 6.37974 6.74107 7.22813 10.7323 +3914 4 44.0754 24.0079 5.20592 -32.7636 -20.0017 -25.3594 +3915 6 37.3054 29.188 32.8461 11.1431 -5.59449 16.1726 +3916 4 36.8523 29.4202 33.6742 6.83247 1.44061 -4.51415 +3917 4 36.6742 29.3068 32.1579 -22.7291 3.94299 -14.9304 +3918 6 0.907991 24.8221 21.2346 15.0832 19.7352 -4.57067 +3919 4 1.06453 25.2816 20.3717 -1.39622 -8.03116 21.3543 +3920 4 1.45755 25.2897 21.9154 -11.7661 -11.1398 -13.6241 +3921 6 53.0192 2.206 13.0014 -0.818186 11.5483 2.08343 +3922 4 52.7824 1.81345 13.8314 -6.90556 -15.4066 8.50991 +3923 4 53.4537 3.0128 13.31 2.83183 5.68595 -7.528 +3924 6 24.3052 33.9756 13.9324 20.4312 -11.5489 10.0229 +3925 4 23.7773 33.1726 14.1229 5.8111 10.1191 -2.33499 +3926 4 25.2169 33.8698 14.327 -30.0349 3.28274 -10.0023 +3927 6 40.9302 19.2912 0.318024 -15.3988 27.4065 1.86032 +3928 4 41.1581 18.3902 0.297675 9.36546 -44.4479 -0.119704 +3929 4 41.7646 19.7516 0.396104 7.20249 9.57203 1.55489 +3930 6 38.311 32.026 21.5914 -16.5672 24.1097 -12.7773 +3931 4 37.7777 31.3762 21.1012 4.07846 0.69211 1.97712 +3932 4 37.9765 32.9287 21.3171 8.34414 -28.994 10.9395 +3933 6 42.3062 34.9979 16.9676 -25.16 18.3345 5.87282 +3934 4 41.5364 35.0784 17.5803 19.0968 -0.611651 -8.13832 +3935 4 42.7061 34.1505 17.1117 7.13758 -14.417 1.0169 +3936 6 19.559 24.3289 21.9471 -10.3882 -39.985 28.3228 +3937 4 19.0651 23.5074 22.2416 22.0177 25.9498 -5.97634 +3938 4 18.911 24.732 21.3859 -10.0006 10.9377 -12.5795 +3939 6 21.0734 3.08215 14.9508 5.66735 1.93263 4.27485 +3940 4 21.953 3.50152 15.1067 -15.9394 -6.36392 -7.95302 +3941 4 20.9814 2.87634 14.0019 2.73511 2.88399 3.27523 +3942 6 16.4416 12.1461 28.5328 0.855962 3.79198 1.54672 +3943 4 16.9672 12.6551 29.168 -2.37031 -0.949071 -4.41291 +3944 4 15.802 12.7688 28.1665 0.405815 -3.95107 1.98596 +3945 6 29.5641 4.71626 21.7415 17.492 -20.3905 -14.0863 +3946 4 29.717 3.79719 21.4198 0.937107 17.7735 8.56359 +3947 4 28.6765 4.939 21.4721 -9.06619 5.19467 -0.439365 +3948 6 47.4133 12.088 13.4013 -19.6032 -12.6622 16.1152 +3949 4 46.7677 12.2286 12.6843 7.8139 0.82382 7.69043 +3950 4 46.8958 11.6888 14.1608 19.5987 16.3505 -27.3211 +3951 6 26.4348 0.0314913 5.59163 -38.6673 11.9556 1.59378 +3952 4 25.5144 0.513751 5.59151 44.3701 -31.5426 2.21012 +3953 4 26.2832 40.9933 5.84663 -4.6239 23.4679 -5.56234 +3954 6 20.8211 34.8097 41.3598 6.97593 19.5597 16.9804 +3955 4 20.8796 35.753 41.6458 -3.00787 -20.9192 -8.75426 +3956 4 21.5767 34.358 41.784 -4.89338 4.10004 -2.4608 +3957 6 12.6876 17.479 1.38718 -1.79098 16.5747 12.6529 +3958 4 12.721 17.2085 2.3151 1.79447 -6.15344 -4.56661 +3959 4 12.6249 16.7029 0.834077 -0.882684 -12.7315 -6.97767 +3960 6 30.0809 10.1879 8.41184 2.17826 -2.71045 -21.4672 +3961 4 29.3744 10.7602 8.07412 2.70218 -2.7161 1.39802 +3962 4 29.921 10.0821 9.33998 -2.4398 0.0699553 19.6849 +3963 6 36.338 5.45526 23.9203 5.99313 10.0946 16.1749 +3964 4 36.1182 6.35936 23.6236 3.48165 -5.42435 1.21963 +3965 4 37.0503 5.55216 24.5976 -11.7354 -2.45534 -11.6386 +3966 6 34.0137 39.9398 19.5054 17.9066 -9.75089 21.0607 +3967 4 34.5988 39.5452 20.1731 -15.7075 -1.02338 -1.83906 +3968 4 34.6431 40.5289 19.082 -7.6391 9.5881 -14.1485 +3969 6 25.1112 29.0201 17.0007 35.0878 36.529 -22.1514 +3970 4 24.4917 28.3695 17.2244 -30.3786 -36.8419 16.5077 +3971 4 24.8604 29.2867 16.1023 2.15056 -2.21883 6.37313 +3972 6 28.5036 21.3308 6.52422 21.0338 -5.55128 30.7615 +3973 4 28.0688 21.6386 5.71574 5.06238 16.4658 -0.926129 +3974 4 28.989 22.0506 7.05137 -24.5794 -13.751 -30.0602 +3975 6 18.6637 26.1498 0.432001 -8.53447 25.4727 10.2843 +3976 4 18.1393 25.3713 0.533905 -9.92127 -26.6833 -5.54807 +3977 4 18.1707 26.7698 1.00478 10.6071 3.27379 -7.60185 +3978 6 10.9817 29.7047 15.4617 -41.5317 11.7513 13.4553 +3979 4 11.6879 29.3608 14.9846 35.2501 -21.9962 -32.1318 +3980 4 11.3889 29.9926 16.2601 5.02956 8.45945 23.8164 +3981 6 33.4827 3.76017 10.5773 -2.41261 -0.304069 24.838 +3982 4 33.4731 3.39919 11.5182 2.46452 11.5285 -31.0446 +3983 4 33.5847 4.73535 10.6555 -0.240223 -15.9168 2.16837 +3984 6 12.2973 28.805 23.0387 -1.70787 -5.55619 5.61474 +3985 4 12.73 29.6571 22.9381 2.67417 5.94729 -0.690524 +3986 4 11.5024 28.994 23.5653 2.03311 -0.198261 -3.05575 +3987 6 13.0915 10.291 41.0216 -35.9662 5.53295 8.52282 +3988 4 13.8386 10.0408 41.5246 29.6538 -8.48465 17.7322 +3989 4 13.4107 10.5366 40.1733 8.17866 7.18603 -23.992 +3990 6 45.8162 29.981 22.3537 -23.4909 -34.782 -9.94688 +3991 4 46.3605 30.6906 22.6479 19.8522 18.211 11.3118 +3992 4 46.1638 29.1315 22.7274 -3.04842 19.9099 -5.39144 +3993 6 41.5671 12.1372 14.78 12.0724 6.03101 -10.0784 +3994 4 40.8481 12.1001 15.4119 -11.2612 -2.38036 6.73971 +3995 4 41.9114 13.0311 14.8874 5.93112 4.19505 -0.667369 +3996 6 18.1729 7.20363 24.1739 -28.0382 48.7978 3.52623 +3997 4 17.4064 7.85498 24.128 33.406 -18.9268 -1.93395 +3998 4 17.7199 6.38321 24.1568 -14.2968 -40.16 -0.285645 +3999 6 1.47767 28.308 7.57167 -25.5616 27.2209 -25.1393 +4000 4 0.827452 27.622 7.68711 2.49251 -16.9659 6.86802 +4001 4 0.906232 29.0217 7.18328 24.331 -5.18373 6.93061 +4002 6 11.3359 12.3164 24.0718 -23.8013 37.4997 -14.7667 +4003 4 11.6691 13.0224 24.6595 3.51665 -15.1291 3.43827 +4004 4 11.6925 11.4858 24.3227 20.8697 -21.176 20.4973 +4005 6 17.9852 40.4684 24.4198 -2.05389 -13.7174 33.2687 +4006 4 18.291 40.9889 23.6947 8.79563 24.1615 -11.819 +4007 4 17.8495 41.0209 25.2243 7.13458 -7.65509 -20.9696 +4008 6 25.5964 7.43792 34.0141 13.5012 12.0052 -20.5927 +4009 4 25.8913 7.969 33.2287 -3.90825 -14.1502 17.4414 +4010 4 24.6674 7.63663 34.1466 -9.57807 0.741149 3.27376 +4011 6 16.9692 36.3856 7.79034 -41.9934 -28.8773 9.66508 +4012 4 16.1027 35.9203 7.98218 37.4859 8.56847 -14.648 +4013 4 16.8197 37.2026 8.24874 12.7807 20.325 5.07796 +4014 6 12.4125 39.1679 36.8113 4.83627 -30.6012 -9.1357 +4015 4 13.2866 39.4994 36.9682 3.20673 22.8904 8.84646 +4016 4 12.7018 38.3069 36.4569 -23.4958 5.90479 1.90955 +4017 6 23.4443 1.91649 37.7131 1.30421 0.985484 -2.89526 +4018 4 22.7028 1.66545 37.1374 7.60384 11.2995 4.79583 +4019 4 23.7753 2.79308 37.4363 -6.35903 -5.24233 -3.11404 +4020 6 26.6169 34.8556 39.068 -18.8945 24.0174 -16.1573 +4021 4 25.9011 35.0209 39.7003 9.00825 -5.11239 -0.809586 +4022 4 26.448 35.531 38.356 7.64302 -20.2436 14.8851 +4023 6 44.7566 35.572 23.174 8.53117 -4.94531 -21.3447 +4024 4 44.5551 36.3183 23.7275 -7.66893 11.3086 12.1688 +4025 4 44.9082 35.9286 22.2729 -0.906387 -11.1819 10.3159 +4026 6 34.6091 35.4265 26.6991 -7.96701 8.74937 -1.29134 +4027 4 33.7558 35.2865 27.1578 16.0802 3.93421 -4.37465 +4028 4 35.2785 35.5457 27.4013 -9.86041 -2.80018 -4.60569 +4029 6 12.4308 29.8402 9.37325 4.00701 15.5633 13.1387 +4030 4 12.6298 30.2095 10.2592 0.427445 -8.8693 -11.9579 +4031 4 11.9163 30.5385 8.94302 -0.259504 -4.09781 -0.505047 +4032 6 46.4536 41.3715 16.9585 -0.509472 -10.7221 -3.48983 +4033 4 46.3968 0.20327 17.5639 0.209317 7.43894 6.10767 +4034 4 46.3711 41.769 16.0793 0.075994 -2.20044 0.741492 +4035 6 39.1811 31.047 24.0166 -28.3946 14.7902 -31.7872 +4036 4 39.0009 31.2944 23.0615 15.0891 -8.50563 28.3067 +4037 4 38.282 31.1199 24.3765 13.6746 -2.33731 7.34059 +4038 6 40.5375 9.75603 28.9763 9.47615 -22.8392 -16.3574 +4039 4 40.717 8.78834 28.9749 -4.02124 18.0325 0.597023 +4040 4 40.0442 9.94417 29.7674 -4.45736 4.50836 13.2228 +4041 6 33.5752 11.9033 22.735 -22.7947 23.9621 15.9921 +4042 4 33.2963 12.1808 21.8555 7.18969 -8.33444 -8.87292 +4043 4 33.0376 12.5465 23.2695 22.9257 -24.0379 -3.52442 +4044 6 29.0301 38.739 2.44557 13.7604 -11.9544 -20.6568 +4045 4 29.2066 39.6607 2.23242 1.09325 2.62923 1.14408 +4046 4 28.4566 38.7797 3.20164 -8.68487 1.4276 10.4377 +4047 6 51.2789 6.14828 28.303 0.614736 -0.570337 1.8431 +4048 4 51.6973 5.27456 28.1665 -1.53436 11.093 -0.261734 +4049 4 51.6265 6.73477 27.6091 2.17001 -12.1019 4.10374 +4050 6 34.1129 16.6124 14.0322 -32.0491 -20.8609 -4.49638 +4051 4 33.8537 17.5241 13.9801 -4.99199 17.3104 -1.82528 +4052 4 35.0495 16.5739 14.0336 36.3732 5.94549 -0.19423 +4053 6 34.4398 40.0505 7.51971 -1.5967 1.86622 -34.5907 +4054 4 34.4907 40.736 6.82898 6.47702 11.7366 29.0204 +4055 4 34.1466 39.3906 6.89306 -3.09667 -23.6565 15.965 +4056 6 42.5416 22.9885 4.36731 16.709 1.02816 -9.65968 +4057 4 42.6773 23.0677 3.40021 -12.3994 2.37358 9.8727 +4058 4 41.6332 23.2481 4.59133 5.34809 1.54884 -5.45539 +4059 6 1.43335 11.7249 10.5915 17.9648 34.7983 -1.93775 +4060 4 2.18855 11.6351 9.93392 -25.2532 9.63542 18.7746 +4061 4 1.3761 12.7012 10.8984 13.7257 -41.7135 -20.7702 +4062 6 10.0197 17.1509 40.4023 -3.34945 -21.541 12.0793 +4063 4 9.07741 16.8499 40.449 26.596 5.40866 2.75879 +4064 4 10.6028 16.482 40.874 -24.6204 18.7768 -14.392 +4065 6 26.3793 1.16939 23.7984 9.5834 26.112 -20.0106 +4066 4 26.3482 1.63114 22.915 -1.08564 -15.7005 23.7132 +4067 4 26.8817 1.81632 24.3342 -3.35925 -10.5223 -0.68284 +4068 6 4.47487 16.2271 39.0058 33.4959 -10.553 -10.6989 +4069 4 4.63618 15.8937 38.0801 -2.33968 7.70086 24.4633 +4070 4 5.35244 16.1813 39.5129 -32.5033 1.65679 -19.7071 +4071 6 24.3835 39.8482 14.0852 2.84697 7.18038 -0.286146 +4072 4 24.1877 40.6985 13.6429 5.77715 -11.144 2.19115 +4073 4 25.1234 39.4426 13.6288 0.754333 1.29636 -3.16103 +4074 6 19.9701 19.0136 10.1131 -5.22385 -12.8057 23.8822 +4075 4 19.1001 19.3633 10.3498 -0.643873 5.13605 -7.14836 +4076 4 20.1315 18.3631 10.8504 3.64009 16.176 -24.2707 +4077 6 45.2329 15.0638 25.3099 -19.5547 20.2245 12.2671 +4078 4 44.4482 15.622 25.4263 4.62838 7.04728 2.57625 +4079 4 44.8851 14.3824 24.752 0.155489 -22.5403 -14.0061 +4080 6 47.6439 32.9533 29.9771 4.38746 -1.69347 6.40492 +4081 4 47.8622 32.5347 30.8309 -5.05982 6.77924 -7.14273 +4082 4 46.6855 33.0215 29.8843 -3.06966 -4.44082 4.14054 +4083 6 9.30872 14.1631 35.6268 19.7088 14.7601 29.7215 +4084 4 10.221 13.8687 35.4779 -5.99131 -8.3331 -9.89462 +4085 4 9.36538 14.5282 36.5395 -10.4264 -5.45721 -18.9107 +4086 6 0.534978 28.7509 32.1461 -15.0727 14.1973 -4.1115 +4087 4 0.468283 29.1163 31.2513 -2.72678 6.96628 5.64212 +4088 4 0.834469 27.866 31.9601 7.81775 -11.1437 7.49829 +4089 6 26.1375 14.1816 40.8286 20.1166 -40.7048 30.4826 +4090 4 26.3241 13.5573 41.5993 3.0023 20.8863 -27.3959 +4091 4 25.2151 14.3343 40.9319 -22.5068 13.4131 -3.44564 +4092 6 38.0468 1.72227 37.358 -19.6589 11.4537 -4.22791 +4093 4 38.2764 1.77906 36.4154 -1.14244 -2.14966 7.97792 +4094 4 37.182 2.20858 37.4052 20.9639 -13.8426 2.93072 +4095 6 43.3928 21.0193 0.385094 -33.4221 -4.11839 13.5226 +4096 4 43.2305 21.8771 0.864972 20.5484 -13.2955 -16.2126 +4097 4 44.243 20.9573 41.8451 7.78799 18.4844 3.58779 +4098 6 29.7343 12.3918 17.0888 -10.4088 14.6249 -44.7733 +4099 4 30.3573 13.1084 17.3121 -1.69191 -12.5137 15.8564 +4100 4 29.5365 11.7717 17.7855 9.28071 1.18848 24.195 +4101 6 21.0845 11.002 35.643 19.2467 11.9534 29.728 +4102 4 20.8387 11.9292 35.5336 -5.23529 -0.657509 -1.91086 +4103 4 20.6782 10.509 34.9529 -15.7216 -13.7754 -25.5995 +4104 6 24.3584 22.1274 17.054 -19.116 4.6391 -13.6617 +4105 4 24.8062 22.8618 16.6504 0.246813 15.5697 -7.02352 +4106 4 25.0581 21.6899 17.4914 19.3443 -19.237 19.9016 +4107 6 44.2632 9.62803 6.15095 12.4515 -7.11379 4.41615 +4108 4 44.6939 9.46248 5.31272 4.1824 -3.3463 -6.13814 +4109 4 43.3875 9.94101 5.94426 -13.441 6.05535 2.74078 +4110 6 40.7983 2.89203 6.29118 6.30341 -5.06299 2.94692 +4111 4 40.283 3.08384 7.0886 -2.93464 8.08246 -11.2803 +4112 4 40.6425 3.53992 5.58152 -5.48248 3.30556 7.46891 +4113 6 23.4927 29.787 25.2074 -17.9847 -14.6764 23.1638 +4114 4 22.9663 29.9524 24.4255 0.505661 2.84572 -7.25135 +4115 4 24.3189 30.243 25.1366 19.4862 15.0746 -12.06 +4116 6 45.2253 20.6067 7.48804 -4.5495 -5.9569 -0.737791 +4117 4 44.4771 20.6075 6.85512 7.98227 -4.73543 5.3389 +4118 4 45.4897 19.6858 7.65762 -3.7219 7.49041 -4.48952 +4119 6 44.1869 26.5802 16.6604 -2.53584 -23.4697 22.3036 +4120 4 44.4278 26.4187 15.7655 11.491 9.41288 -34.0672 +4121 4 43.9629 25.6676 16.9 -3.51956 3.82806 13.7521 +4122 6 23.5847 27.0608 18.0875 4.92857 -1.63386 -8.1099 +4123 4 23.1417 26.2886 17.6568 -1.85204 16.5134 12.3838 +4124 4 22.9956 27.5067 18.7318 1.2523 -15.787 -12.8337 +4125 6 45.1423 16.1006 8.91925 -12.5826 4.07054 -12.5551 +4126 4 44.1756 16.0018 8.7625 13.8686 2.25455 7.61002 +4127 4 45.2849 15.9649 9.86163 -1.87368 -3.25302 7.37304 +4128 6 39.0195 15.168 5.20911 22.9796 -5.95468 -13.3261 +4129 4 39.8169 15.5451 4.76197 -16.8333 -0.501818 4.44847 +4130 4 38.2997 15.7872 5.12886 -6.79784 14.0419 -3.1922 +4131 6 40.4728 4.77172 20.098 -25.5728 -7.96759 5.38455 +4132 4 41.2852 4.73631 19.62 25.1414 0.345713 -9.53623 +4133 4 40.6586 5.20983 20.9254 2.90807 4.2574 9.49937 +4134 6 35.8334 28.4358 39.8978 -29.6544 -30.7382 0.627816 +4135 4 35.064 27.7738 39.8775 30.8234 30.4338 1.60118 +4136 4 36.4992 28.0138 39.3349 2.0747 -0.608826 -0.916217 +4137 6 26.5626 3.56604 2.67563 -12.8067 -1.70274 -2.52813 +4138 4 26.0244 3.493 1.8476 6.72613 8.7381 24.6483 +4139 4 26.0719 4.09981 3.36162 5.66066 -13.1585 -23.5937 +4140 6 2.95645 21.6514 17.6824 -3.82104 6.40043 0.291571 +4141 4 2.91294 22.1823 18.4797 -6.37673 0.600795 10.7096 +4142 4 3.68258 22.033 17.1814 1.62588 2.51689 -6.09233 +4143 6 12.886 25.0591 25.9256 19.9254 19.7817 -8.37483 +4144 4 13.3104 25.904 25.618 -13.2675 -16.998 3.60223 +4145 4 12.0452 24.9678 25.4656 -4.65807 1.85418 -5.64346 +4146 6 41.5793 20.6554 14.1751 9.92193 3.46069 0.25892 +4147 4 42.3122 20.2044 13.7523 0.767115 -12.7084 -7.64783 +4148 4 41.9959 21.4893 14.4245 -8.84771 2.34114 1.73285 +4149 6 1.24495 39.6039 11.5378 16.0363 -42.6363 3.17437 +4150 4 1.64626 38.7705 11.134 -18.3255 36.4754 4.46196 +4151 4 1.41802 39.4632 12.4909 -5.9615 12.3362 -8.98123 +4152 6 16.0218 39.0109 34.0619 -0.331369 12.6721 -5.4452 +4153 4 15.5475 38.1996 33.7806 5.75571 19.7523 -4.5346 +4154 4 15.9899 39.7855 33.4251 -7.29137 -28.599 9.21448 +4155 6 20.567 7.02475 25.5588 2.3848 7.82756 -0.6535 +4156 4 20.909 7.86076 25.1782 -7.45606 -9.2474 3.61042 +4157 4 19.6275 6.99553 25.3185 5.42042 5.25175 -3.5088 +4158 6 45.1928 25.5902 39.1787 -21.925 2.17874 18.9559 +4159 4 45.8631 26.0435 38.6892 20.8233 13.1115 -15.3132 +4160 4 45.3324 24.6675 39.0115 4.42968 -17.7425 -2.36405 +4161 6 19.9342 40.1138 28.2835 12.5964 -14.0671 -7.25792 +4162 4 19.0067 40.1593 28.0096 1.46425 5.68018 7.52545 +4163 4 20.128 40.8224 28.917 -7.48392 0.334406 -3.99949 +4164 6 26.4878 14.2069 27.3684 6.98603 -7.23951 -28.1548 +4165 4 25.5412 14.1932 27.2537 -20.7302 0.754551 -2.34698 +4166 4 26.606 14.4537 28.2745 0.836708 4.29804 26.5652 +4167 6 51.3489 25.9487 3.45136 10.7849 20.7191 -13.686 +4168 4 51.0453 25.2386 4.01334 -1.8549 -15.8565 1.21982 +4169 4 51.853 25.5737 2.69356 -6.32678 0.0553236 13.0587 +4170 6 20.1633 26.1247 2.67289 8.83438 -16.1267 5.68002 +4171 4 20.5345 25.2411 2.88723 -1.43181 13.9101 -1.64203 +4172 4 19.9438 26.1088 1.72974 -0.778515 0.427063 3.21599 +4173 6 3.13549 11.9681 27.2232 16.3616 22.3682 9.86323 +4174 4 2.68005 12.663 26.7181 4.92926 -3.58697 -0.471129 +4175 4 3.70389 12.4466 27.8862 -15.0224 -10.9098 -14.9284 +4176 6 30.1793 26.3687 4.00051 28.7119 -30.2966 58.1206 +4177 4 30.7801 25.8341 3.46925 -1.584 2.83444 -17.1702 +4178 4 29.6371 26.9341 3.51662 -25.563 30.6813 -37.7958 +4179 6 19.3205 20.6733 30.5441 -31.721 -6.25106 8.6959 +4180 4 19.1895 21.5008 31.0287 11.509 1.10551 -1.6952 +4181 4 20.2026 20.5869 30.2 22.6938 9.52703 -0.947482 +4182 6 13.5381 36.2475 0.344803 0.685356 24.2985 -17.2657 +4183 4 13.9232 37.1122 0.0997808 14.0363 -10.2996 17.9143 +4184 4 12.867 36.2368 41.5779 -17.3214 -19.7281 -1.62589 +4185 6 13.6931 21.7661 35.9637 -11.3229 -11.9655 -19.5688 +4186 4 13.4645 21.416 35.0694 1.68887 6.71419 14.5774 +4187 4 14.5559 22.1488 35.8465 12.3178 6.48213 0.887249 +4188 6 39.4176 1.76287 25.342 34.0854 -16.9064 9.57103 +4189 4 40.0026 2.33061 25.8435 -14.6367 28.4588 7.32056 +4190 4 40.0689 1.04185 25.2643 -19.5027 -7.65211 -10.5764 +4191 6 18.2964 6.13492 35.8264 -1.82227 -5.92686 -23.3299 +4192 4 18.1639 5.26767 36.254 2.04199 12.8657 6.45456 +4193 4 18.4232 6.85005 36.4651 0.375802 -9.94466 7.47089 +4194 6 2.53148 24.639 10.0969 -49.4669 34.6161 -0.50772 +4195 4 3.3243 24.1433 10.0889 43.7683 -7.59463 9.24933 +4196 4 2.65209 25.5465 10.4987 14.0059 -27.2835 -7.72375 +4197 6 35.8204 9.94567 1.34298 17.6587 14.9905 11.506 +4198 4 36.311 10.4135 0.64327 -4.10869 -3.12473 7.53129 +4199 4 36.1923 10.315 2.19711 -13.0886 -16.0695 -26.9686 +4200 6 29.0171 17.933 41.5847 -7.4648 10.4738 41.1296 +4201 4 28.4325 17.2741 41.1888 4.90819 -0.226834 -17.309 +4202 4 29.634 18.3354 40.9804 6.59061 1.40283 -25.0927 +4203 6 46.0097 27.0807 25.8707 -17.7195 2.90801 -6.40423 +4204 4 46.7639 26.9189 26.4445 5.86789 -6.79057 7.62258 +4205 4 45.3727 26.3443 25.9794 8.73043 2.74283 1.98831 +4206 6 28.1087 10.6569 35.9055 -15.3417 -26.5964 -30.9314 +4207 4 27.3182 11.0018 35.4375 11.5227 2.30745 10.116 +4208 4 28.4572 11.2922 36.5111 4.26863 23.9808 15.1461 +4209 6 25.95 20.1976 24.7821 3.31321 9.63686 -4.79579 +4210 4 26.7637 20.7132 24.6155 -9.40037 -7.04512 10.7501 +4211 4 25.7749 20.1865 25.7378 6.19451 4.49283 1.81458 +4212 6 32.2481 30.2487 10.2005 -0.567171 -33.888 25.4585 +4213 4 32.5217 30.8918 9.54162 14.407 -2.03846 -6.18424 +4214 4 32.9483 29.5597 10.4163 -8.30199 27.6945 -16.8968 +4215 6 5.04696 34.3919 23.8165 18.9071 9.10073 -2.65681 +4216 4 5.8517 34.9395 23.7378 -5.43375 -12.4066 7.00495 +4217 4 4.47737 34.8578 23.2154 -15.6684 -1.23826 -5.97721 +4218 6 29.6446 34.9396 23.1073 8.37026 13.2143 1.46186 +4219 4 30.146 35.227 23.8877 -4.79805 -2.96005 -2.8646 +4220 4 29.6355 33.9874 23.1398 -0.169507 -13.2925 4.62646 +4221 6 52.2021 25.2197 36.2484 0.203165 -13.9358 18.8619 +4222 4 51.9199 25.3821 37.1814 5.20177 -0.668093 -22.6011 +4223 4 52.2823 24.2449 36.2046 0.468647 8.20491 -0.432122 +4224 6 6.9564 41.2598 14.9786 17.963 -12.3423 -19.5336 +4225 4 7.05881 41.0384 15.8913 -5.14113 -1.34859 16.0369 +4226 4 7.66895 40.7276 14.5577 -14.5347 12.9973 2.09466 +4227 6 27.6566 39.1405 4.67566 -15.1179 -12.1251 22.0677 +4228 4 26.8424 38.6352 4.89635 10.0979 9.09612 -9.05456 +4229 4 28.2356 39.0161 5.44259 -0.0995191 -2.46215 -4.35417 +4230 6 44.4488 15.8848 30.3925 -17.4686 4.63448 -32.2897 +4231 4 43.6243 16.41 30.3099 13.0937 -10.0294 9.08699 +4232 4 44.649 15.6212 29.457 1.77951 4.94888 23.2191 +4233 6 27.3024 38.1054 13.0907 0.224949 -17.5042 -4.12929 +4234 4 27.6483 37.328 12.5833 -5.61487 10.2238 13.6353 +4235 4 27.1416 37.8221 14.0243 3.20236 0.189733 -16.1751 +4236 6 26.6663 32.9851 36.8362 -23.8807 -10.2072 10.655 +4237 4 27.4028 33.4987 36.5569 24.2269 11.6336 -10.1628 +4238 4 26.2735 33.5165 37.5295 -1.35435 2.25064 8.62378 +4239 6 26.3226 28.1988 31.7158 32.4613 11.5871 5.04411 +4240 4 26.7492 28.3346 30.8217 -6.54697 -0.873531 32.5908 +4241 4 26.9302 28.5068 32.4691 -17.7353 -8.90623 -33.5497 +4242 6 49.2114 35.7792 23.3295 1.46842 19.8344 9.76806 +4243 4 49.8184 36.2235 23.9243 -3.28067 3.63886 4.6357 +4244 4 49.746 35.0988 22.9506 10.5329 -22.9043 -16.5919 +4245 6 44.2369 15.3613 33.5367 -0.695853 -9.37614 14.4104 +4246 4 44.9539 15.1613 32.9326 3.59625 1.2978 -8.28609 +4247 4 43.6189 15.9562 33.0977 0.720121 5.36694 -8.04858 +4248 6 16.6517 35.2697 14.032 -14.9609 -5.91625 -15.8105 +4249 4 16.8478 36.086 14.4923 5.97715 10.4369 8.21626 +4250 4 15.7311 35.3947 13.7134 15.021 -1.16653 5.16189 +4251 6 45.2991 21.4701 12.0564 -47.5016 11.1637 19.3857 +4252 4 45.9844 21.105 11.5386 20.9258 -26.0087 -22.2564 +4253 4 44.5936 20.7913 12.2178 25.8967 12.3347 -6.55717 +4254 6 51.6438 5.33792 20.1099 7.42219 12.4384 36.9688 +4255 4 51.7517 5.79258 20.9932 -2.42789 -17.2577 -23.3969 +4256 4 50.9203 5.81642 19.7 -6.55397 4.36408 -6.3714 +4257 6 22.6153 27.305 0.955308 -12.5158 1.22245 6.52354 +4258 4 21.8819 27.8542 1.31405 9.62632 -7.19502 -8.89748 +4259 4 23.0385 27.8458 0.276527 0.370713 4.24399 -0.0338259 +4260 6 46.8868 12.1467 22.3289 10.3551 9.03073 -1.70047 +4261 4 46.473 12.5446 21.5671 -2.12653 7.07083 -14.4911 +4262 4 46.1639 11.6922 22.7348 -15.0603 -15.1984 17.3736 +4263 6 33.7555 5.60359 25.2366 8.41588 -11.9289 0.48427 +4264 4 34.4013 5.10188 24.7086 -2.4022 4.68399 3.96997 +4265 4 33.0757 5.86414 24.6127 -5.93503 4.46215 -0.558809 +4266 6 44.2476 18.1243 27.2334 30.0322 17.9475 -5.65933 +4267 4 44.0927 18.7931 26.5253 0.465456 -9.97561 17.2792 +4268 4 45.207 18.2464 27.4768 -29.0014 -6.50023 -5.41996 +4269 6 5.27814 37.006 29.0846 -42.995 37.8911 -11.235 +4270 4 4.83357 37.8684 28.7516 22.264 -36.721 16.075 +4271 4 6.19253 37.2033 29.2507 20.6764 5.54169 3.86921 +4272 6 20.033 5.01392 38.9409 6.34377 -32.2179 -4.45843 +4273 4 19.8009 5.56625 39.6765 -4.47316 13.7366 14.9565 +4274 4 20.2948 4.14306 39.3359 -6.8578 18.535 -7.22498 +4275 6 17.9112 2.77214 33.8677 -16.6976 6.01838 23.4157 +4276 4 18.6113 3.34266 33.5322 6.18073 5.31505 -2.96417 +4277 4 17.3526 3.28629 34.5246 17.6921 -17.568 -20.3177 +4278 6 5.56788 23.3774 22.3326 -7.55986 13.5725 18.1102 +4279 4 6.25354 23.3408 21.6412 1.32241 8.57002 8.68476 +4280 4 5.72116 24.1623 22.9232 3.31135 -14.4794 -19.5174 +4281 6 12.7438 28.0244 40.0809 14.6998 26.4392 -25.8726 +4282 4 12.8099 29.0023 40.1455 -0.120572 -14.3051 2.54846 +4283 4 13.1526 27.8611 39.1965 -9.74214 -4.86635 20.6942 +4284 6 50.5283 38.8014 28.4207 -10.7676 14.1923 -1.71082 +4285 4 51.0354 39.5212 28.0559 20.7423 0.788408 -10.014 +4286 4 49.7626 39.3052 28.7255 -7.2831 -13.6434 5.52883 +4287 6 33.5501 8.21498 17.8605 -32.9279 -35.4008 39.405 +4288 4 33.9027 8.87262 17.3189 24.9798 40.0041 -36.6225 +4289 4 33.9074 7.37462 17.5752 8.43731 -7.27798 -4.46199 +4290 6 34.6457 34.7004 17.7764 -12.4293 -15.9601 -10.9704 +4291 4 35.1223 35.3606 18.2944 6.48769 -0.751965 0.253856 +4292 4 35.2388 33.9528 17.5616 -1.14344 9.31979 5.2604 +4293 6 40.7233 5.29016 23.4005 8.26322 -6.33781 10.3585 +4294 4 41.4774 4.87923 23.8731 -9.49225 7.91527 -13.3731 +4295 4 40.0307 4.6112 23.3711 2.34129 5.18948 -0.0201455 +4296 6 16.9127 27.7621 14.4682 52.6044 -4.68653 -2.89351 +4297 4 16.0711 28.1345 14.4444 -59.8378 16.6137 -1.60006 +4298 4 17.4608 28.5627 14.561 1.7801 -9.46587 0.070581 +4299 6 29.0363 14.6633 5.00698 9.76413 -9.29226 13.7719 +4300 4 29.5096 13.8001 4.93115 -9.10936 16.1071 1.03458 +4301 4 28.802 14.7746 5.95339 2.50956 -1.40994 -14.9204 +4302 6 36.8445 17.7203 5.07362 13.6951 -24.032 -28.6565 +4303 4 36.3003 18.4061 5.45056 -9.17068 14.5835 0.43155 +4304 4 36.9783 17.8862 4.10178 -4.81067 2.65881 25.6667 +4305 6 27.7152 25.5071 34.8558 20.6182 -10.3116 10.9196 +4306 4 28.4128 25.1948 35.4689 -8.51497 -1.72528 -14.7569 +4307 4 27.3626 26.2325 35.3632 -10.8781 12.0961 2.58089 +4308 6 24.7577 17.2803 18.064 -3.70908 -2.75228 5.17573 +4309 4 25.2464 17.9619 18.5343 4.21458 5.85634 1.04617 +4310 4 24.0216 17.073 18.6635 3.98676 -0.349172 -5.54229 +4311 6 30.1887 1.57939 5.82314 -15.3902 21.7461 -57.8894 +4312 4 29.5204 1.81013 6.46928 0.301846 -2.58557 7.21893 +4313 4 29.8355 2.03332 4.95505 20.4457 -28.7719 49.9963 +4314 6 37.4518 25.9014 8.44867 -40.4019 -33.5071 29.4213 +4315 4 38.3881 25.8301 8.67833 5.27698 -2.9507 2.74989 +4316 4 36.9261 25.2192 9.0364 31.48 35.4073 -33.2345 +4317 6 24.7717 7.01585 2.25321 22.1725 6.13312 -2.42992 +4318 4 25.3573 6.36243 2.67285 -8.4103 6.94319 2.38151 +4319 4 23.8861 6.6751 2.35128 -10.8992 -4.25211 1.65182 +4320 6 25.7992 38.8457 10.7505 7.22571 37.8744 -16.0906 +4321 4 26.2906 38.615 11.5103 14.31 -23.6918 34.358 +4322 4 26.1189 39.766 10.6411 -14.7913 -5.88601 -10.6141 +4323 6 0.557249 13.5851 28.1314 4.10373 25.7622 10.4527 +4324 4 0.335523 12.7734 27.7191 -4.86664 -22.4284 -15.6315 +4325 4 0.332586 13.4422 29.0593 -0.0574933 0.663208 0.855409 +4326 6 20.4027 17.1068 12.0342 -11.148 -26.8285 -23.5414 +4327 4 20.2541 17.2545 12.9674 -4.18463 -1.09026 14.619 +4328 4 19.9228 16.2663 11.7843 12.058 20.2306 8.20324 +4329 6 30.9875 7.38585 16.6706 43.1327 18.1844 -1.13431 +4330 4 31.2844 7.10043 15.7746 -9.95685 2.73348 15.1831 +4331 4 31.8198 7.8213 17.056 -34.7561 -19.1709 -8.28734 +4332 6 10.1956 5.78615 12.1691 19.1166 9.414 40.461 +4333 4 10.1305 6.30649 11.4071 -1.6074 30.0602 -42.5686 +4334 4 9.61456 5.08708 11.9844 -30.6818 -38.1141 -6.43609 +4335 6 18.4382 31.3444 24.1606 1.21336 -6.12525 2.83497 +4336 4 18.3965 30.3858 24.3134 -0.788465 1.61506 0.642095 +4337 4 18.2608 31.7571 25.0112 -0.825834 1.26386 0.0223154 +4338 6 27.8905 29.2615 29.2809 39.8074 15.5588 -29.008 +4339 4 28.4007 29.5348 28.4528 -32.3375 -5.53357 22.8869 +4340 4 28.6323 28.9656 29.8273 -8.8667 -4.73078 13.1255 +4341 6 38.3648 15.4483 29.7818 29.0993 -31.9427 29.9284 +4342 4 38.2401 14.49 30.0972 1.05022 38.774 -16.5136 +4343 4 39.2299 15.7257 30.2111 -34.0699 1.82394 -15.2271 +4344 6 21.7074 34.7851 5.58078 8.19375 -39.9271 5.99876 +4345 4 21.4944 33.8203 5.80476 0.548141 38.153 -5.97617 +4346 4 20.9458 35.3238 5.82701 -5.25279 -7.50871 2.73382 +4347 6 18.2117 16.8293 1.01571 -12.7233 9.06437 9.63769 +4348 4 17.5846 17.1799 0.363518 5.67247 -6.87112 -0.25098 +4349 4 17.8106 17.1001 1.86952 7.78128 -5.5379 -6.7416 +4350 6 43.5131 18.5098 39.3469 22.8992 -24.809 -24.744 +4351 4 42.9473 19.1501 39.756 -14.025 22.4758 -1.21679 +4352 4 43.733 18.7829 38.41 -14.2449 3.90475 27.8798 +4353 6 17.7973 10.0724 35.5497 11.3899 1.25644 -17.5776 +4354 4 17.9076 9.35875 36.1674 -1.9111 -9.85084 12.7139 +4355 4 18.4727 9.8826 34.8661 -11.1758 5.45367 7.50841 +4356 6 36.5836 30.5676 29.0795 -26.735 36.4018 -15.4516 +4357 4 36.5101 31.4618 28.6208 1.83791 -30.0083 14.6126 +4358 4 37.4767 30.2665 28.9506 20.8385 -5.81304 -4.31186 +4359 6 38.5024 35.9654 10.4302 15.5283 7.61871 55.4477 +4360 4 38.713 36.6589 11.1463 -7.3207 -22.805 -33.4203 +4361 4 38.3781 35.1576 10.9824 1.19538 10.4075 -12.7486 +4362 6 43.3976 18.7941 34.3717 -4.38817 -12.2014 30.3889 +4363 4 43.0627 18.1963 33.6763 0.988603 1.53223 14.3474 +4364 4 43.2603 18.4022 35.293 0.0857578 9.32555 -37.8245 +4365 6 11.0576 40.22 6.11206 -6.0837 -9.04747 -4.15047 +4366 4 11.6426 40.8981 6.46389 1.08734 7.77423 2.35531 +4367 4 10.1474 40.5638 6.06331 9.30243 4.06404 0.87098 +4368 6 48.3282 13.7431 24.4718 -8.87905 25.3224 16.0087 +4369 4 47.8536 13.4091 23.7195 -8.5266 -8.47545 -16.9724 +4370 4 47.8942 14.6072 24.6749 14.3726 -19.4181 -2.72093 +4371 6 1.47819 25.7805 23.7819 -0.0731812 -13.4431 -3.72387 +4372 4 0.822875 26.4404 23.4927 11.4147 5.84295 7.97453 +4373 4 2.19403 26.202 24.2849 -5.19934 9.21725 -1.17005 +4374 6 20.5754 0.0393205 21.1081 25.6075 5.05031 -17.3956 +4375 4 19.8484 0.361847 21.622 -17.4675 -5.38456 12.9096 +4376 4 20.5586 40.9849 21.0455 -11.1839 1.66381 7.6849 +4377 6 37.6642 12.8991 30.7037 -9.9457 -20.8438 -29.8221 +4378 4 37.1371 12.462 29.9889 18.2914 6.1257 8.16018 +4379 4 36.9745 13.1334 31.2979 -14.5618 11.4049 21.409 +4380 6 49.47 17.3794 9.25364 5.30826 8.19981 -9.14457 +4381 4 48.5231 17.6061 9.31556 15.6584 -1.48937 -5.70503 +4382 4 49.8852 17.9254 8.53549 -14.9109 -12.0851 17.4703 +4383 6 34.3662 5.35535 17.144 13.1974 2.57034 -29.0571 +4384 4 34.5198 5.2998 16.166 0.54303 4.43319 20.4174 +4385 4 33.4623 5.07036 17.243 -16.3394 -6.24992 8.38082 +4386 6 14.7833 27.6665 0.0728061 -6.74966 -7.64198 -7.69033 +4387 4 13.9925 27.8402 41.4242 12.1928 3.48747 9.75107 +4388 4 15.1668 28.5017 0.401621 -7.96817 -0.0208253 -5.02821 +4389 6 48.8656 15.5206 20.7458 -9.86138 0.136748 20.6241 +4390 4 49.0651 16.3952 20.4263 0.209458 6.72405 -7.85333 +4391 4 49.1204 14.8922 20.0789 6.79298 -9.16117 -16.8166 +4392 6 23.807 40.3882 20.3905 -3.398 23.5063 24.1729 +4393 4 23.5208 41.0259 21.1064 9.42377 -19.8715 -22.5683 +4394 4 24.7282 40.1652 20.6096 -6.91059 4.34471 -3.10789 +4395 6 35.1847 31.5046 13.7021 -31.0181 23.9456 -35.1619 +4396 4 34.2309 31.3725 13.4471 24.927 2.88592 7.27171 +4397 4 35.3946 30.8036 14.2945 4.95161 -20.634 19.3451 +4398 6 10.9658 9.01332 39.5058 -15.2714 21.9147 -18.395 +4399 4 10.5965 9.92979 39.4 9.97221 -25.6919 2.69722 +4400 4 11.1763 8.90125 40.4322 -2.36933 4.41176 3.08643 +4401 6 53.2091 4.88966 16.6226 -14.1926 -12.3632 -40.3028 +4402 4 53.7513 5.3458 17.242 7.58091 5.46958 35.753 +4403 4 52.4727 4.38631 17.0042 6.19997 4.37068 9.30068 +4404 6 7.84194 33.803 26.1542 28.433 15.6582 -32.2535 +4405 4 7.6241 34.0763 27.0539 6.31302 8.01731 -0.629847 +4406 4 8.43319 34.4994 25.6777 -29.4311 -29.3345 32.8186 +4407 6 31.3263 27.9445 6.27534 4.23256 -31.0286 -11.1959 +4408 4 31.9071 27.4889 6.92578 -8.71467 11.4818 -6.48617 +4409 4 31.157 27.2952 5.54778 3.06851 13.2477 11.4148 +4410 6 31.3665 2.16522 41.0549 8.67281 8.84877 18.675 +4411 4 31.764 2.22522 0.0553479 -13.0589 -8.62932 -24.7178 +4412 4 31.1679 1.24258 40.8683 -0.324156 -6.15668 4.61941 +4413 6 33.7659 4.25511 35.8987 -17.0312 -3.82062 1.06926 +4414 4 34.343 3.86214 36.5812 -9.75418 2.24627 -3.55813 +4415 4 32.8029 4.08293 36.1352 33.1171 1.27305 -1.46623 +4416 6 47.9658 16.0637 29.8469 2.67107 -7.93457 21.4822 +4417 4 48.7643 16.2814 30.3583 0.589987 0.219824 -12.8585 +4418 4 47.4335 15.6159 30.5321 -1.60863 4.8928 -15.0046 +4419 6 49.3312 10.0914 28.5924 -0.28152 -2.80953 -5.35856 +4420 4 48.5695 10.6519 28.8218 4.15282 -2.34898 -5.74021 +4421 4 49.4995 10.1231 27.6243 -2.44246 2.9592 14.5426 +4422 6 21.4058 27.7857 29.7524 8.26148 -8.5709 13.934 +4423 4 21.8935 27.2574 30.4222 -7.07544 0.199766 -18.4014 +4424 4 21.2999 28.6278 30.1835 -3.48366 18.9655 1.67033 +4425 6 11.6744 39.4982 25.8468 7.90293 7.18169 -2.58674 +4426 4 12.2285 38.7361 26.0681 1.40058 3.92388 1.36909 +4427 4 10.8023 39.1241 25.7384 -12.6269 0.672841 -0.990747 +4428 6 22.9696 39.3076 7.85132 -6.07512 -3.4122 -1.68244 +4429 4 22.2682 38.6524 7.98148 0.173976 5.86283 1.52023 +4430 4 22.7132 40.0561 8.41581 1.67877 -3.24138 -2.90234 +4431 6 42.551 35.9177 31.3369 11.821 -63.1978 11.5341 +4432 4 42.5803 35.466 30.4647 -4.4966 22.226 11.3725 +4433 4 42.4036 36.8376 31.2573 -6.84366 36.9754 -14.9488 +4434 6 33.6582 14.7374 3.97797 20.0935 -7.17859 -40.4554 +4435 4 32.8645 15.2412 4.10613 -20.5582 11.3796 6.05129 +4436 4 33.8494 14.8388 2.99484 -4.26498 -3.76663 30.6135 +4437 6 36.6985 8.59579 17.521 17.5186 -20.4505 -17.8166 +4438 4 37.2174 8.05238 16.87 -10.1577 15.2162 18.3492 +4439 4 36.2061 9.2161 16.9727 -6.85471 3.87096 1.58869 +4440 6 20.8134 32.4132 17.3224 -0.15138 -19.2041 8.32641 +4441 4 20.2101 33.0681 16.9297 -8.31182 -6.81981 10.9196 +4442 4 20.3788 31.7527 17.9441 5.10322 26.2393 -19.6477 +4443 6 20.7088 35.3183 14.0957 -11.7768 -25.3725 -13.8548 +4444 4 21.261 35.5893 13.3574 6.77827 9.37653 -4.07387 +4445 4 20.8679 35.9028 14.8214 6.04206 13.2639 9.85712 +4446 6 20.2377 2.51389 40.1721 -7.12285 -8.41588 24.6249 +4447 4 19.7963 2.31331 41.0421 14.3479 1.04867 -24.2175 +4448 4 20.7189 1.71371 39.9103 -4.456 1.41042 1.49289 +4449 6 15.0332 14.4679 0.20602 13.2809 -6.14192 -34.7112 +4450 4 15.5535 13.6508 41.8516 -13.9549 30.8146 5.37449 +4451 4 15.3124 15.2392 41.5458 -1.11857 -25.4589 11.3055 +4452 6 24.8198 37.3334 18.5262 -9.71694 12.1129 21.4379 +4453 4 24.5044 38.0178 17.9266 6.55828 0.975012 -4.85481 +4454 4 24.4839 37.6255 19.4009 7.37292 -12.3795 -13.3571 +4455 6 3.16023 27.7824 5.25746 -7.59771 -9.49442 8.09122 +4456 4 2.57386 27.9573 6.05068 26.7372 -11.3185 -11.6141 +4457 4 4.04718 27.3724 5.4685 -26.4098 5.90831 3.92345 +4458 6 37.1274 39.059 36.0582 -20.0626 39.3499 3.12364 +4459 4 37.4397 39.697 36.7497 0.155645 -22.9334 -11.3782 +4460 4 37.5741 38.2261 36.1006 18.9616 -13.4483 8.05827 +4461 6 41.3496 16.372 3.85306 -8.55617 -26.9153 -3.74777 +4462 4 41.2863 17.3336 3.84263 10.0449 1.9656 13.5452 +4463 4 42.0245 15.9886 4.46176 -7.16622 24.1057 -6.4954 +4464 6 15.5715 3.1806 35.3543 4.49903 -8.79025 -44.1337 +4465 4 15.0747 3.51322 34.5661 7.45265 -4.29831 20.3405 +4466 4 15.2394 3.62675 36.1076 -11.9729 17.6287 21.2524 +4467 6 33.1697 24.252 7.98021 17.4163 -35.2043 24.5175 +4468 4 33.373 24.4892 7.07941 -5.88693 14.0606 -13.9779 +4469 4 32.5854 24.8767 8.38373 -10.6809 23.5743 -3.02942 +4470 6 35.8792 29.7453 15.5891 -14.351 2.75051 -7.10357 +4471 4 36.7674 29.6271 15.8378 44.9858 5.9786 2.16229 +4472 4 35.4705 29.0828 16.1298 -19.5083 -3.35284 8.18061 +4473 6 17.5951 36.8258 41.8642 -13.8657 0.640745 -39.4401 +4474 4 18.0986 36.7885 0.752491 19.5286 0.61142 14.8967 +4475 4 18.204 36.9888 41.0995 -4.16013 -2.78766 23.3657 +4476 6 26.5622 4.14757 31.1303 -11.2209 -47.8968 -15.8259 +4477 4 27.2883 4.63526 31.456 28.856 27.2634 11.544 +4478 4 26.9475 3.23966 30.9928 -12.9924 23.1667 5.46977 +4479 6 31.9456 1.33308 34.4467 -12.9904 6.64728 -11.4505 +4480 4 32.8071 1.19449 34.8725 -11.0783 -3.65615 8.33208 +4481 4 31.1956 1.0725 35.0172 18.2758 0.413953 2.527 +4482 6 24.503 14.7492 2.38048 9.24208 -0.0712211 -0.802907 +4483 4 24.1928 14.0003 2.93847 14.4388 11.7071 -7.35684 +4484 4 25.4689 14.9243 2.53228 -19.8697 -9.93034 3.69906 +4485 6 25.7634 20.9148 27.525 0.946636 -0.977661 -1.30084 +4486 4 25.4997 20.5428 28.395 3.38508 9.32598 -11.7317 +4487 4 25.6529 21.8806 27.5755 0.284497 -3.23384 4.14496 +4488 6 18.1477 40.1511 30.6505 2.638 -12.7558 5.82509 +4489 4 18.5379 39.2542 30.773 0.361891 20.0487 -3.45439 +4490 4 18.8736 40.7943 30.5754 -0.793328 -5.73314 0.616918 +4491 6 46.8137 23.9108 24.5765 -6.45001 25.2139 -38.2053 +4492 4 46.156 24.4917 24.0674 25.2521 -23.4518 17.6745 +4493 4 47.3533 23.4819 23.8873 -7.92808 3.44465 4.72259 +4494 6 45.5993 22.6806 26.5072 -4.87261 3.12825 -8.14378 +4495 4 46.0946 22.9584 25.7273 -3.42504 -3.72677 5.16847 +4496 4 46.0209 23.1613 27.2227 -5.79148 -3.32105 5.25932 +4497 6 20.0977 4.47574 26.7104 -1.85738 36.2438 14.3308 +4498 4 20.3766 5.37803 26.4593 -10.8474 -9.08605 12.6513 +4499 4 20.6066 3.98633 26.1049 14.7704 -34.5311 -24.6657 +4500 6 35.268 26.6035 12.5547 25.3434 4.5593 25.1203 +4501 4 35.7054 25.7374 12.5354 -13.4481 2.49909 -6.64065 +4502 4 35.8431 27.0669 13.1929 -15.092 1.56141 -12.9558 +4503 6 3.25549 33.9664 12.2985 -21.2488 -6.99508 3.93395 +4504 4 2.30606 33.7392 12.3085 7.5225 -4.25393 -1.25154 +4505 4 3.25844 34.917 12.332 8.53638 16.5693 1.24934 +4506 6 36.6808 1.27299 25.5856 -28.051 -2.86161 17.5249 +4507 4 37.6164 1.46673 25.6835 8.21338 5.71919 3.59986 +4508 4 36.1703 1.6124 26.3685 15.6278 -2.9361 -18.4357 +4509 6 16.8737 4.664 24.0353 -31.9925 -2.01789 -27.2632 +4510 4 15.8786 4.73848 23.8401 40.5517 -2.65221 8.73903 +4511 4 17.2589 4.19458 23.2519 -3.48506 7.68373 17.7614 +4512 6 39.6701 15.0742 7.83356 -1.71206 -7.05123 2.14494 +4513 4 39.2725 14.2274 8.02711 2.44544 -9.24519 17.4119 +4514 4 39.3892 15.1326 6.9218 7.69265 14.011 -7.76766 +4515 6 9.96731 20.1909 2.92864 -13.1382 1.0323 -16.144 +4516 4 9.71565 20.5309 2.05786 3.65664 7.03968 6.64426 +4517 4 9.8995 19.2377 2.78093 4.24026 5.10291 12.3576 +4518 6 23.4077 4.6159 15.27 -3.48308 -16.1533 -1.5067 +4519 4 23.619 4.71624 14.3536 6.29203 -7.01184 -22.1313 +4520 4 23.1672 5.50294 15.4683 -4.33935 19.8524 20.6561 +4521 6 23.5267 41.6518 17.9122 -9.44104 0.807914 21.3506 +4522 4 23.7067 41.2659 18.7956 7.59245 -0.294373 -11.029 +4523 4 22.6339 0.0834245 18.0732 1.82991 3.48892 -13.1537 +4524 6 30.9316 4.82324 1.33107 45.9774 51.3713 7.99935 +4525 4 30.5768 4.02682 1.05687 -28.0042 -54.4029 -17.3695 +4526 4 31.8094 4.8761 0.879215 -15.6392 -0.833181 8.5221 +4527 6 29.2201 33.7587 18.5991 58.073 2.92721 -1.85527 +4528 4 30.1837 34.1183 18.6008 -42.2538 -17.2347 0.0641557 +4529 4 28.6837 34.5413 18.5643 -15.6262 17.5996 3.33909 +4530 6 23.1221 16.7099 3.68521 11.8431 -16.3115 0.0733348 +4531 4 23.6562 16.338 2.95547 -9.45134 2.67217 9.8165 +4532 4 23.048 17.6538 3.54099 -2.31098 6.59774 -1.54538 +4533 6 34.8961 26.7639 31.7325 -1.99602 4.46994 3.67284 +4534 4 35.0929 27.7139 31.562 -2.18198 -17.8875 -5.58085 +4535 4 35.0252 26.2302 30.9312 2.47742 18.1005 -1.54363 +4536 6 7.11189 40.7663 20.959 14.901 4.90705 15.7674 +4537 4 6.49418 40.4573 20.3006 -5.17655 -2.88906 -15.6427 +4538 4 7.9749 40.9101 20.5297 -6.61986 -3.78335 -7.15935 +4539 6 52.4451 9.69387 11.9379 -8.46192 -13.0679 -16.1645 +4540 4 52.1167 8.90553 11.4509 5.46474 18.3719 13.4625 +4541 4 53.1134 10.0871 11.3593 -6.16158 -0.354597 4.80602 +4542 6 12.0344 32.7576 27.7445 1.28323 7.36678 12.5499 +4543 4 11.2848 32.2741 27.3627 7.37999 2.33687 -5.47139 +4544 4 12.7987 32.654 27.1746 -1.40521 -5.62475 -4.84597 +4545 6 15.7821 18.5441 0.84801 8.76354 -4.35468 -11.8188 +4546 4 16.4439 18.9467 1.42581 -3.0166 1.81121 1.10538 +4547 4 14.9492 18.5892 1.29924 -12.8156 0.756803 9.02992 +4548 6 30.9925 13.9418 7.42386 -4.40747 -9.92517 -19.1249 +4549 4 31.0137 13.4754 6.53341 6.38174 17.9129 28.0089 +4550 4 31.6996 14.6103 7.52177 -5.32565 -11.3142 -7.68087 +4551 6 23.9405 39.5605 3.5435 10.8606 -6.43074 -8.73391 +4552 4 24.3095 38.7805 4.04208 -2.00396 18.4511 -18.0645 +4553 4 24.6123 39.8651 2.88148 -9.69774 -9.50421 15.8523 +4554 6 53.2462 13.9551 2.00337 -15.5118 -12.0942 -3.71099 +4555 4 54.104 14.269 2.28215 12.5804 5.35006 1.30654 +4556 4 53.0522 14.3304 1.13281 7.32968 -0.777694 2.32044 +4557 6 29.4483 26.4268 7.81741 -0.171572 11.4439 -18.4732 +4558 4 29.8672 26.7876 7.00927 -3.33338 -4.99995 18.6366 +4559 4 28.5088 26.3872 7.58736 -4.03891 -2.78124 5.15679 +4560 6 24.6251 23.6043 31.0935 -26.8137 17.7603 -44.4691 +4561 4 23.7139 23.2229 30.9355 29.773 11.0738 8.78977 +4562 4 24.7983 24.2076 30.2965 -2.98074 -30.8217 36.523 +4563 6 33.658 19.3188 40.511 -4.29932 4.0975 7.85681 +4564 4 33.8365 18.6271 41.1728 0.0947513 0.993086 -5.72158 +4565 4 34.3002 19.2334 39.7953 0.390848 -1.03282 -3.03706 +4566 6 0.558986 35.9852 14.2205 11.1667 11.0015 21.0521 +4567 4 1.21386 36.1432 14.9149 3.92292 -5.96876 -2.97707 +4568 4 0.043734 36.7876 14.3014 -15.3768 6.08493 -10.5247 +4569 6 7.05222 12.7587 15.7802 -26.1824 -15.4106 14.8382 +4570 4 6.35773 12.5373 16.4499 19.2033 7.53925 -13.5919 +4571 4 6.88557 12.0803 15.1093 4.12905 5.75416 0.888 +4572 6 7.8802 3.87979 22.4264 4.564 -30.6165 13.1651 +4573 4 7.61737 4.55637 21.8154 -5.12813 13.4305 -13.5146 +4574 4 7.59435 3.01808 22.0419 3.92228 16.9329 8.71162 +4575 6 50.747 32.0919 16.246 0.584829 29.9532 -6.88448 +4576 4 49.8575 31.8158 16.477 -3.66132 0.0213613 -0.234359 +4577 4 50.6533 33.048 15.9617 2.92819 -31.696 10.1835 +4578 6 15.3083 18.2099 30.0577 17.4273 -12.3999 25.5818 +4579 4 14.8795 18.523 29.2753 -13.2188 2.60124 -19.4058 +4580 4 14.9888 17.3027 30.2404 2.47215 8.3937 -6.40515 +4581 6 36.7253 25.4508 33.3862 -30.1432 30.6395 -17.6873 +4582 4 35.9871 25.9696 32.8546 42.334 -36.2451 27.5582 +4583 4 36.7428 24.5171 33.143 -7.68133 1.91065 -3.3758 +4584 6 16.5208 21.8449 20.262 -11.2097 8.64672 -3.63533 +4585 4 16.6085 20.9267 19.9682 1.68058 -0.497742 -2.90804 +4586 4 16.3112 22.3946 19.4823 4.36577 -8.59001 6.07269 +4587 6 44.2833 3.11948 30.0766 -7.99673 -6.73576 30.9987 +4588 4 44.2005 2.2232 29.7402 -0.794022 -7.70278 -4.62871 +4589 4 44.5183 3.67066 29.3503 7.77568 15.2131 -24.9404 +4590 6 51.0808 14.1269 27.7758 -27.047 -14.2895 -4.28411 +4591 4 51.175 15.071 27.7901 8.66575 19.7266 0.878182 +4592 4 50.1173 14.0309 27.5969 15.0189 -4.76366 3.10402 +4593 6 54.1497 15.8755 27.1203 10.9044 -5.07506 15.753 +4594 4 54.6247 15.0341 27.411 -19.35 18.5916 -21.6107 +4595 4 53.6213 15.8397 26.2863 11.6919 -13.2292 13.7718 +4596 6 26.7269 15.1716 34.5247 3.07047 6.28357 -2.56105 +4597 4 26.6547 16.15 34.5201 9.87746 -16.6036 -4.19036 +4598 4 27.4477 14.9176 33.917 -5.54963 13.4877 1.89491 +4599 6 34.6713 2.21044 27.481 35.3652 -9.42756 14.1603 +4600 4 34.3712 2.0217 28.3795 -9.10436 3.38048 -0.887416 +4601 4 33.9282 2.37922 26.9258 -24.4077 6.67858 -6.22498 +4602 6 36.3012 17.6491 40.388 5.86113 23.4658 6.44349 +4603 4 35.7206 17.1804 39.7974 -3.43874 -12.7236 -2.47465 +4604 4 36.6864 17.0408 41.0377 -6.22241 -0.114851 -7.42509 +4605 6 26.2819 0.194243 33.0916 -21.1162 -1.74839 5.89968 +4606 4 26.0541 0.792538 33.818 7.17118 8.51167 2.05738 +4607 4 25.4361 41.6393 33.0097 0.772233 -7.73624 -3.23605 +4608 6 5.19547 35.5715 31.6247 14.6733 -21.492 26.4929 +4609 4 6.10271 35.831 31.8735 -9.75028 2.17691 -1.53344 +4610 4 4.97694 36.0548 30.8519 -3.41417 18.4244 -29.6169 +4611 6 20.2195 22.0294 35.119 8.25657 -3.203 11.321 +4612 4 19.9286 21.1888 34.7559 -2.68712 -4.78598 1.15285 +4613 4 20.5567 21.7901 36.0152 -5.29706 4.10974 -20.8318 +4614 6 15.9087 36.5843 36.9399 0.69981 -30.9087 31.3945 +4615 4 16.5764 37.2836 37.0377 -3.33596 -3.14632 -1.27145 +4616 4 16.032 35.9777 37.754 -5.87689 21.7482 -34.0408 +4617 6 30.95 22.3912 3.57027 12.227 -51.3484 -20.5494 +4618 4 31.0645 22.6091 4.4902 1.82476 2.59415 19.1922 +4619 4 31.2691 21.4218 3.50648 -13.7255 40.3499 2.75328 +4620 6 47.0405 8.41049 14.2025 -7.26712 -13.7585 -23.7685 +4621 4 46.2225 8.31623 13.6472 18.9804 2.55096 13.7682 +4622 4 47.7321 7.85584 13.7597 -18.0416 11.4216 8.02226 +4623 6 34.1106 18.627 3.15563 -0.4946 23.1394 22.2065 +4624 4 34.672 18.2914 3.86301 0.996255 -3.71784 -4.49801 +4625 4 34.2399 18.1173 2.36738 0.542984 -13.2578 -17.3669 +4626 6 26.7976 25.3916 12.343 -23.6037 -44.5624 17.4882 +4627 4 27.2059 26.2338 12.4335 13.1462 29.8808 4.32264 +4628 4 26.6887 24.995 13.243 7.37483 11.5945 -21.6739 +4629 6 22.6215 25.7777 30.8835 17.9212 -8.3502 11.6983 +4630 4 23.3826 25.7056 31.4928 -6.70991 6.16838 -4.71983 +4631 4 22.2455 24.8881 30.8847 -4.10822 -0.13742 -3.2228 +4632 6 23.6315 9.78689 35.7599 5.48292 -2.30097 -0.625566 +4633 4 22.8113 10.2893 35.7248 -4.77612 1.7474 -0.383276 +4634 4 23.3643 8.87406 35.5171 2.31753 16.9109 3.97959 +4635 6 10.4044 36.7742 9.63922 -25.0741 -4.1625 3.51028 +4636 4 9.48479 36.4361 9.55892 17.1497 7.1291 1.06445 +4637 4 10.7029 36.9295 8.73946 3.49181 4.27039 -8.54773 +4638 6 4.00239 32.4234 25.8687 17.3833 10.7639 11.9139 +4639 4 4.35688 32.9952 25.1699 -1.7627 -0.965582 -1.95819 +4640 4 3.3252 31.8731 25.4905 -12.2764 -14.2405 -10.2138 +4641 6 29.0717 26.0252 18.6551 27.2015 -27.7815 2.54409 +4642 4 28.1485 25.9947 18.9226 -9.28828 -8.18845 2.68073 +4643 4 29.5616 25.1801 18.9271 -24.0321 31.3207 -7.4501 +4644 6 15.3034 1.33037 27.9713 -8.15532 13.2931 -1.88459 +4645 4 14.9824 0.900448 27.1643 -4.10476 8.37726 9.18093 +4646 4 14.8435 2.19317 28.1161 8.64797 -17.4448 -9.70896 +4647 6 48.6122 2.88813 22.9601 -14.0575 20.6462 10.9468 +4648 4 48.3097 2.01316 22.7294 4.97712 -8.72373 -1.92059 +4649 4 49.4728 3.0448 22.5739 5.56154 -9.57595 -10.4155 +4650 6 53.0134 0.348391 19.7218 2.72624 -2.60203 -3.14968 +4651 4 52.5877 42.0257 20.5538 -0.625041 0.289898 3.74318 +4652 4 52.305 0.305612 19.0628 -0.905041 -0.864478 -1.55308 +4653 6 1.39118 17.4858 17.9447 -8.50794 14.6458 12.7327 +4654 4 1.24353 17.4779 16.9894 -1.31782 -10.0732 -1.96873 +4655 4 1.47925 16.6123 18.3551 -1.8326 -9.29856 -10.4725 +4656 6 37.8975 19.0277 37.6053 -28.6618 15.029 -11.7184 +4657 4 36.9647 18.7897 37.7838 11.6122 1.96204 1.16191 +4658 4 38.4406 18.4447 38.1174 10.3965 -16.3488 12.6679 +4659 6 26.9855 30.3558 38.071 9.50079 1.40194 -4.36533 +4660 4 26.0886 30.216 37.7369 5.39533 7.19535 -1.12484 +4661 4 27.2954 31.2276 37.7499 -13.0308 -11.5285 -0.168161 +4662 6 20.0885 18.5747 3.04679 -6.02291 21.5949 -15.2672 +4663 4 19.9787 17.7407 3.50085 7.53739 -11.7285 12.3408 +4664 4 20.8981 19.0299 3.33477 -4.38138 -14.9723 0.744253 +4665 6 35.0861 6.94018 4.08702 3.04221 -3.62035 -0.583554 +4666 4 35.6351 7.18342 3.33325 6.4301 -2.1748 -2.62446 +4667 4 34.2564 7.39563 3.93984 -10.6534 0.652929 2.2495 +4668 6 22.2213 37.08 31.2556 -28.1532 13.1327 42.6182 +4669 4 22.1563 36.8958 30.3458 -2.68084 -5.78815 -35.014 +4670 4 21.2899 37.3194 31.5407 35.2494 -6.03647 -12.8067 +4671 6 12.3954 22.364 41.8234 21.4337 26.9075 -8.21443 +4672 4 12.9612 23.1595 41.5956 -22.2624 -27.6618 12.5485 +4673 4 11.7092 22.295 41.1522 0.74395 2.83494 0.343647 +4674 6 43.2331 30.3213 23.157 26.8689 32.5799 1.85734 +4675 4 44.1495 30.0558 22.8796 -21.7207 5.89602 6.32158 +4676 4 43.3514 31.2801 23.4416 -6.45211 -30.9956 -6.78246 +4677 6 16.5257 8.07813 16.6617 -19.4309 -12.5216 11.6481 +4678 4 16.3886 8.34983 15.7476 7.00958 2.01583 -5.14722 +4679 4 17.4107 8.32004 16.9428 8.9294 8.4681 -2.86418 +4680 6 10.0506 8.65043 31.7756 -2.39508 10.2278 -10.4865 +4681 4 10.14 7.97578 32.4103 1.95442 -36.8206 12.1998 +4682 4 10.116 9.39125 32.3649 -0.107045 27.388 0.472024 +4683 6 10.1509 6.49695 25.6483 14.6726 -6.33183 2.00995 +4684 4 9.37694 6.15153 26.0805 -12.3653 -8.75157 5.1154 +4685 4 9.82248 7.1865 25.0601 3.70088 -0.958502 2.30736 +4686 6 49.8668 7.2369 25.5225 -24.0329 9.97804 -6.35029 +4687 4 50.053 6.31696 25.3599 8.14544 -13.6468 -2.92498 +4688 4 50.6696 7.6642 25.7982 18.0374 4.82749 5.17198 +4689 6 18.4641 37.5693 33.932 -1.74635 9.46172 -1.89257 +4690 4 17.7617 38.2474 34.0853 10.1616 -18.2299 -3.47398 +4691 4 18.0542 36.6946 34.0238 -8.30855 4.53024 1.19921 +4692 6 32.1897 34.7964 39.2558 32.2313 -17.5381 13.0656 +4693 4 32.48 34.3381 40.0896 -7.23509 10.7133 -18.5379 +4694 4 31.2879 35.0284 39.3813 -31.6037 5.0658 8.82 +4695 6 49.5304 23.9104 4.45569 25.8701 3.67026 -38.321 +4696 4 49.7808 23.1947 5.01942 4.2809 -18.8946 17.0996 +4697 4 48.8132 24.3493 4.85794 -31.8244 16.1567 21.064 +4698 6 6.0606 24.4992 33.9345 -0.638471 -2.64646 7.7036 +4699 4 6.7001 23.7849 33.7997 2.17947 5.97399 -8.00372 +4700 4 5.47521 24.1274 34.6146 -0.567039 8.82042 -5.77933 +4701 6 1.71497 22.9937 24.1827 2.23241 21.1509 -1.27791 +4702 4 1.62302 23.9425 23.95 -0.486435 -10.8617 3.92094 +4703 4 0.825214 22.7289 24.4403 -5.44701 -4.12175 2.39318 +4704 6 12.4657 16.5565 32.3481 -44.3953 42.3465 -23.9812 +4705 4 13.2256 16.0186 32.4214 25.6927 -27.9273 24.4997 +4706 4 11.8347 16.6394 33.1026 23.5286 -12.3088 -0.369419 +4707 6 21.3722 37.3857 27.9432 8.33623 1.67622 30.3175 +4708 4 21.2745 37.3852 27.0022 -8.47587 6.30229 -26.1478 +4709 4 20.7646 38.0573 28.2974 0.343549 -1.37388 -6.67046 +4710 6 27.2371 40.835 28.8059 -14.5618 2.70883 26.0148 +4711 4 26.5104 41.4636 28.9519 7.17104 -1.72995 -14.6333 +4712 4 27.2442 40.3637 29.6524 5.83721 -3.62297 -8.28664 +4713 6 0.999535 21.7321 13.5318 -29.3194 4.17708 -0.571391 +4714 4 1.85706 21.6318 13.8745 50.1621 -4.04822 5.83187 +4715 4 0.493313 21.4968 14.3164 -12.4374 2.61082 -2.41507 +4716 6 22.3196 2.57547 8.74609 19.5097 -5.43411 17.7027 +4717 4 22.9517 3.10624 8.26305 13.4452 6.72454 -0.92593 +4718 4 21.5477 2.63817 8.2102 -22.9662 -0.14239 -10.9727 +4719 6 29.9886 17.8486 8.24374 -1.93571 4.49032 -2.67939 +4720 4 29.0601 17.6146 8.32603 -5.42798 -1.41354 1.1127 +4721 4 30.4131 17.4547 9.01282 4.29332 -3.23535 5.29369 +4722 6 3.62824 37.7086 25.7053 -21.3362 8.32154 -6.60892 +4723 4 4.42904 37.184 25.8405 -4.94962 -9.47676 -0.42012 +4724 4 2.83762 37.1591 25.4673 21.6133 3.65171 5.88982 +4725 6 26.7972 27.6476 36.3581 -47.4115 -5.5291 12.7506 +4726 4 26.8465 28.2624 35.6306 8.29087 8.74477 -10.4705 +4727 4 25.8218 27.6191 36.6005 30.1762 -0.597939 -6.56813 +4728 6 13.3509 25.3111 38.1214 6.90903 -15.9492 13.2692 +4729 4 13.3459 24.3911 38.4732 0.919555 17.3618 -5.73458 +4730 4 14.144 25.7168 38.5298 -8.43807 -1.25323 -5.48633 +4731 6 49.7161 27.2636 6.73274 -18.8339 5.2299 -32.7408 +4732 4 49.5935 26.3653 6.40806 5.58405 -0.645115 8.82912 +4733 4 49.2001 27.7791 6.04852 15.3529 -4.94049 26.886 +4734 6 39.7451 11.5811 10.2076 8.75523 -9.51322 -11.6408 +4735 4 40.371 10.9447 9.80262 -5.32314 14.1891 9.76509 +4736 4 39.1233 11.799 9.49079 2.50191 2.43793 7.76023 +4737 6 17.4883 24.9894 35.5591 -19.4762 1.01983 7.35275 +4738 4 17.0975 24.7887 34.694 2.72786 0.423626 1.28381 +4739 4 18.4353 24.8575 35.5073 10.004 -2.92602 -7.93295 +4740 6 45.0832 34.9807 31.8277 24.5651 -3.79623 6.38158 +4741 4 44.3095 35.5111 32.0501 -8.6141 -4.27399 -12.5931 +4742 4 44.9123 34.3632 31.1055 -12.5508 0.508806 -0.453023 +4743 6 30.2187 9.89463 31.3271 7.05348 4.55507 6.68413 +4744 4 30.4541 10.7656 30.9635 -3.12777 -8.04008 8.45875 +4745 4 30.1355 10.0083 32.293 1.90576 1.32601 -8.54322 +4746 6 32.3712 9.2149 6.61373 28.8381 -35.7198 -39.9492 +4747 4 32.1726 8.66567 5.78496 5.01502 20.0116 29.9298 +4748 4 31.5547 9.49954 6.96481 -36.3246 12.521 14.22 +4749 6 9.26959 24.9556 35.9161 1.96832 15.842 -17.2096 +4750 4 8.91298 25.4858 35.1726 -0.127744 -15.1166 11.0351 +4751 4 9.85583 25.5957 36.3463 -2.24606 -10.0757 2.02076 +4752 6 40.3298 1.49261 18.8755 10.6299 1.30292 -21.7 +4753 4 39.6194 1.80532 19.3944 -35.8146 17.5344 12.5449 +4754 4 40.7796 0.936194 19.4956 21.1502 -18.4862 6.40423 +4755 6 5.26901 10.6323 30.4328 -1.07618 -0.575959 25.8078 +4756 4 5.0059 11.4532 29.9824 1.00544 3.53991 6.4134 +4757 4 5.36238 10.8297 31.4225 -4.75078 2.46468 -31.0333 +4758 6 25.6472 11.7043 25.6564 -2.85241 -30.912 5.54365 +4759 4 25.9319 12.4737 26.1319 5.23872 14.1859 6.15637 +4760 4 25.9893 10.9537 26.204 -5.41829 19.961 -14.7301 +4761 6 21.91 20.0664 29.7913 -6.2328 1.4725 0.460556 +4762 4 22.5319 20.0532 30.5545 -13.0709 -9.05965 -9.53591 +4763 4 21.5487 19.1817 29.5606 11.8355 8.09924 7.60661 +4764 6 10.008 19.9919 34.5046 11.2891 -12.0839 -11.2138 +4765 4 9.40296 20.4589 35.0806 -5.60052 -0.834193 8.04722 +4766 4 10.0208 19.0442 34.745 -1.06298 11.667 -2.12072 +4767 6 24.6334 10.3662 12.209 5.25257 18.8662 20.0118 +4768 4 24.6941 9.47775 12.5956 1.57271 8.96717 -2.9517 +4769 4 24.9719 11.0034 12.9045 -11.2568 -27.0384 -15.8586 +4770 6 50.4496 28.283 11.5446 48.5969 7.21476 -25.6728 +4771 4 51.3012 28.7385 11.2434 -32.0883 -19.6524 11.3949 +4772 4 50.1145 28.8771 12.2081 -10.2548 6.02908 11.3498 +4773 6 13.9159 27.6234 25.0588 -25.6331 11.4059 -15.4978 +4774 4 13.5005 28.0493 25.83 5.93925 -3.01588 -8.8098 +4775 4 13.4276 28.0022 24.2718 14.6036 -12.4854 23.8457 +4776 6 46.1589 18.6653 40.4078 -23.2184 -0.389309 -10.7846 +4777 4 45.2349 18.5626 40.0761 15.1795 0.391647 5.46432 +4778 4 46.2048 19.5984 40.6658 -0.558864 -5.77386 -4.91212 +4779 6 32.4746 14.176 27.1227 -16.003 2.1806 5.505 +4780 4 31.9042 13.6172 27.6867 7.52463 5.83279 -7.70325 +4781 4 32.1655 15.0897 27.2802 4.78128 -6.53963 -2.41902 +4782 6 14.0556 36.3553 13.3828 19.8073 6.5728 22.6139 +4783 4 14.1017 37.3298 13.5875 -14.1879 -23.5484 -13.1576 +4784 4 13.3212 36.1206 12.8052 -8.41953 14.8686 -5.40295 +4785 6 1.88392 36.5802 21.9963 -4.52806 -9.18778 1.34501 +4786 4 1.78058 36.5165 22.9531 -3.13652 -1.22736 7.08711 +4787 4 2.81062 36.8013 21.8509 3.08344 1.49572 -0.20158 +4788 6 25.283 31.8665 39.7486 -0.0346121 -4.3463 21.3102 +4789 4 24.9491 32.7147 39.4474 -1.97702 6.83441 1.95234 +4790 4 25.5262 31.9404 40.7015 -5.12155 2.92558 -20.0537 +4791 6 6.47988 22.0137 1.28428 -12.6715 -7.61279 -4.66874 +4792 4 5.53909 21.8738 1.48571 10.6555 3.73696 2.93659 +4793 4 6.5727 22.8978 0.916948 1.0061 5.37498 -0.183021 +4794 6 27.6236 25.0404 4.70626 6.00578 18.2896 15.2827 +4795 4 28.5331 25.4118 4.61276 -17.9968 -6.47987 4.19831 +4796 4 27.2352 25.3966 5.54825 13.7859 -6.49357 -18.8943 +4797 6 21.6401 30.9371 41.2305 6.69834 21.9548 -27.1087 +4798 4 21.276 30.3289 41.855 -17.7491 -18.0709 13.8774 +4799 4 21.0024 31.0127 40.4783 8.64888 -5.56942 17.5854 +4800 6 32.355 18.8729 12.7674 13.4209 4.31066 2.75957 +4801 4 31.3956 18.9706 12.835 4.55688 -5.10905 -10.5867 +4802 4 32.607 18.5493 11.8826 -7.53687 3.28724 6.30822 +4803 6 35.6452 19.4617 21.1556 -9.82604 19.2175 8.60555 +4804 4 35.3405 18.5718 21.3708 -2.26659 -3.59924 -3.4629 +4805 4 34.936 20.0876 21.4701 16.8427 -19.1907 -7.36791 +4806 6 27.6904 17.9595 34.0135 2.51947 12.848 9.8691 +4807 4 28.1207 18.371 33.2456 -3.55582 0.0466306 5.59907 +4808 4 28.0719 18.4525 34.7708 -4.77519 -7.99763 -12.3529 +4809 6 34.1913 39.0308 14.8198 -32.2909 7.81486 42.3772 +4810 4 33.7378 38.3849 14.2709 2.40292 -0.641653 -5.60016 +4811 4 33.4938 39.1934 15.5434 31.6198 -1.67931 -26.5413 +4812 6 28.5078 3.47132 33.888 -4.80695 9.04662 2.15546 +4813 4 27.9441 4.2497 33.8725 -11.1427 -2.20885 -1.07295 +4814 4 29.3801 3.85895 33.8332 18.6007 -6.2612 -1.20104 +4815 6 34.9259 32.1312 6.54177 -41.0464 -12.9808 21.9467 +4816 4 34.0171 32.0297 6.98271 38.7419 4.2921 -24.6555 +4817 4 35.5211 32.1736 7.29951 5.76537 -1.35874 -3.25655 +4818 6 31.8896 6.8799 23.5232 0.89208 3.44668 5.58958 +4819 4 32.4231 6.58347 22.7679 -0.16899 1.4285 3.8543 +4820 4 32.2407 7.75715 23.7826 1.29066 -6.24882 -6.25814 +4821 6 18.8559 1.76458 0.828337 -20.5472 23.3683 -17.7838 +4822 4 18.0266 2.11952 0.42761 13.2396 -12.575 3.84382 +4823 4 19.0445 2.38904 1.53279 3.18086 -1.81057 9.578 +4824 6 26.9929 18.9294 11.856 68.8676 -4.65359 -28.5611 +4825 4 27.3133 19.7685 11.4551 -15.5879 -7.28987 7.59546 +4826 4 26.1136 18.988 12.1267 -55.7646 13.8464 15.3945 +4827 6 43.8351 11.1458 18.4443 23.0031 -19.5153 4.50837 +4828 4 43.638 10.8812 17.5537 -13.1544 4.18059 -17.1583 +4829 4 44.5589 10.5175 18.6246 -1.75483 13.9327 9.72942 +4830 6 33.4946 40.5615 37.6755 15.4013 8.76106 -9.33396 +4831 4 34.0096 40.2689 38.4502 -12.4229 -1.46966 -1.83753 +4832 4 32.5786 40.2698 37.7667 -1.95229 -4.85928 9.55413 +4833 6 15.6186 26.7023 39.419 -29.2453 -49.1617 7.39509 +4834 4 15.4971 26.9949 40.3155 1.17426 12.5786 14.7177 +4835 4 16.1446 27.3092 38.9602 29.5915 33.502 -22.8309 +4836 6 4.38071 13.8775 40.883 9.27553 -14.126 -4.37485 +4837 4 5.31782 13.6454 41.0342 -11.8393 4.50398 0.960258 +4838 4 4.04834 13.2497 40.2173 2.13772 10.7877 7.68198 +4839 6 20.1656 10.4005 38.218 10.8779 4.82467 -13.4554 +4840 4 20.4848 10.7245 37.3555 -10.2589 -5.36296 0.708096 +4841 4 20.9923 10.2607 38.6798 -1.28838 -2.71386 11.844 +4842 6 15.1666 19.24 23.8849 4.49083 -8.21488 3.46045 +4843 4 15.3253 20.1347 24.2296 -1.0797 -1.90309 -4.08137 +4844 4 15.0239 19.3391 22.9299 0.969961 5.53483 11.956 +4845 6 47.8934 28.614 15.7995 12.3109 16.1315 8.54118 +4846 4 47.9523 27.7003 15.5425 0.10403 -15.196 -3.00888 +4847 4 48.6265 28.752 16.4246 -6.57835 -5.21115 -6.70139 +4848 6 29.9259 30.9075 18.965 7.62461 4.23841 -1.37457 +4849 4 29.1117 30.4308 18.7732 -7.06282 -5.88302 -2.4339 +4850 4 29.7134 31.8391 18.8515 -2.57834 1.4724 1.74445 +4851 6 11.9338 35.8178 28.497 -7.27451 6.14295 -10.3733 +4852 4 12.5041 35.9802 29.2427 6.70347 11.4983 16.16 +4853 4 12.1847 34.9375 28.2428 -3.53576 -18.0038 -9.26428 +4854 6 29.972 37.8772 25.486 -12.1052 4.73031 -22.3992 +4855 4 30.2553 36.9663 25.6711 3.40868 8.54106 4.83275 +4856 4 30.3747 38.5051 26.0898 8.03536 -1.45294 10.6494 +4857 6 52.6584 28.1048 32.275 31.4311 4.91254 4.04956 +4858 4 52.2473 28.8547 31.8392 -9.38068 2.35947 -3.12986 +4859 4 53.5924 28.4001 32.3224 -6.05351 -9.99886 1.81474 +4860 6 37.0156 40.0823 11.982 15.2095 -8.99172 -8.52195 +4861 4 36.22 40.5624 12.1833 -15.2617 4.79593 6.40041 +4862 4 37.4101 39.8767 12.8402 0.665617 -0.484924 4.09883 +4863 6 16.6662 16.7824 36.4899 -23.6543 20.4081 -13.3107 +4864 4 16.0299 17.4889 36.7962 20.061 -22.8424 -10.9222 +4865 4 16.728 16.9177 35.5139 -3.3638 -0.555369 18.7216 +4866 6 27.9984 4.17668 38.8431 -6.8633 -1.77316 4.22536 +4867 4 28.9161 4.3061 39.1095 4.06977 1.67187 2.70396 +4868 4 28.0368 3.69267 38.0106 -3.95018 -5.40445 -5.6405 +4869 6 28.9057 0.266004 17.7212 -6.10073 29.2375 -5.44551 +4870 4 28.1786 0.88303 17.5246 8.92385 1.95552 -1.67076 +4871 4 28.4447 41.3635 17.8399 -11.0591 -30.1495 5.35559 +4872 6 22.9291 20.1009 26.2737 12.905 2.01461 18.3128 +4873 4 23.6265 20.0378 26.9508 -1.05622 -6.52034 -10.1156 +4874 4 22.4706 20.8929 26.5742 -3.00423 3.39878 -4.61403 +4875 6 49.3993 29.9017 13.433 -6.38025 27.1117 -0.919919 +4876 4 49.1201 30.8275 13.1802 1.84527 -26.9682 8.98406 +4877 4 48.7504 29.5045 14.041 1.51099 8.43883 -0.914593 +4878 6 2.44855 24.8301 7.30401 -10.5471 2.4163 20.698 +4879 4 2.41495 24.6588 8.2845 -1.1432 9.4633 -23.8545 +4880 4 1.72338 25.455 7.1058 6.30785 -9.44609 7.39061 +4881 6 30.3915 26.4508 14.3344 -6.38639 41.9339 41.7386 +4882 4 31.0669 26.3804 15.0403 -0.162406 -14.5956 -15.076 +4883 4 29.932 27.2875 14.6522 8.5071 -34.3491 -22.1885 +4884 6 27.0361 32.5047 3.13805 -13.013 14.5566 5.91638 +4885 4 26.4776 33.1542 3.63465 13.8957 -14.3888 -12.6314 +4886 4 27.3381 31.8882 3.81715 0.997102 -1.94867 -0.811892 +4887 6 34.2693 14.8073 1.28197 14.9869 -24.9335 -24.2287 +4888 4 35.1732 14.4308 1.1613 -12.3133 12.1546 9.27146 +4889 4 33.7818 14.2606 0.617478 5.51233 18.0169 18.4334 +4890 6 30.0243 8.54272 1.33127 -15.3984 1.11418 15.9731 +4891 4 29.9557 9.47917 1.12547 1.89625 5.05184 -1.94546 +4892 4 29.278 8.4251 1.95594 13.4411 -5.55834 -8.66406 +4893 6 42.5535 11.5155 27.7085 15.437 -3.44919 -13.726 +4894 4 42.3225 12.4337 27.8881 -6.79772 -1.02898 5.45325 +4895 4 41.899 10.9203 28.077 -14.0379 1.06089 7.70623 +4896 6 52.4658 39.5603 17.8381 6.64956 -28.6351 -32.0971 +4897 4 51.7413 39.7621 18.3991 -22.9429 13.2738 25.1291 +4898 4 53.1708 40.1592 17.9962 19.9289 22.995 10.0024 +4899 6 33.211 4.92827 31.629 -12.2211 32.167 9.39859 +4900 4 32.8163 5.83971 31.6275 7.84415 -21.2817 2.59476 +4901 4 32.9135 4.52627 30.8083 -0.68235 -2.18314 -5.10952 +4902 6 6.29493 15.9859 18.7482 13.6791 10.985 9.78561 +4903 4 5.93033 16.6016 19.4273 2.88753 -17.718 -13.1605 +4904 4 5.60754 15.3724 18.4768 -10.6912 0.909102 4.08099 +4905 6 8.51749 14.5386 24.6879 -5.02573 1.07483 -2.93277 +4906 4 9.38168 14.4087 25.0828 4.4136 1.3116 3.34168 +4907 4 8.20169 13.6557 24.4566 1.37146 0.850768 1.15416 +4908 6 22.6856 10.1159 32.1347 3.63858 -5.5341 -7.29103 +4909 4 22.4401 11.0127 32.2731 -27.0162 20.0988 15.0061 +4910 4 23.4682 10.3148 31.6383 25.2173 -15.197 -13.8617 +4911 6 11.2884 2.11431 14.6724 -33.0968 -7.95794 -19.898 +4912 4 10.3134 2.08073 14.4479 21.8664 -1.34414 10.3974 +4913 4 11.7152 2.30811 13.8211 9.70644 2.30495 0.939267 +4914 6 44.9099 15.5878 36.2745 25.7257 2.41581 -13.4012 +4915 4 45.0546 15.5553 35.3019 -10.2235 2.9059 20.3658 +4916 4 43.9848 15.4747 36.4307 -17.7944 -2.84066 -0.111047 +4917 6 9.72168 19.0116 31.2214 10.0341 -21.2505 -12.9994 +4918 4 10.5925 19.389 31.3727 0.996524 0.534629 3.32861 +4919 4 9.08651 19.5363 31.6795 -15.0033 12.5653 12.9482 +4920 6 51.9861 7.59179 16.6767 -2.21949 13.5197 0.492591 +4921 4 52.6037 6.8327 16.6765 -16.3843 6.63384 -16.8766 +4922 4 51.5083 7.75362 15.8118 21.6515 -16.4571 17.7861 +4923 6 31.4364 34.7816 36.4086 3.08769 21.0155 -3.2672 +4924 4 31.7704 34.8477 37.2975 8.82098 -13.2304 13.8104 +4925 4 31.3443 35.7177 36.1951 -3.32863 3.82124 -15.3061 +4926 6 4.22848 15.0876 15.3675 -15.1793 -4.71932 15.5862 +4927 4 4.10446 14.9036 16.3273 5.02277 2.80423 -15.2934 +4928 4 5.16622 15.2495 15.2447 10.6913 1.67801 0.337818 +4929 6 47.7535 20.6847 28.0297 3.73811 3.24498 -1.95167 +4930 4 47.6703 19.7739 27.6852 3.21079 12.9013 3.0329 +4931 4 48.3469 21.1738 27.4217 -9.1514 -8.95746 6.26441 +4932 6 15.7983 1.14885 24.4111 -6.64534 16.957 -16.446 +4933 4 15.3695 0.397874 24.8496 -11.2605 5.13601 -9.62176 +4934 4 15.1572 1.72115 23.8957 14.1067 -25.56 23.4483 +4935 6 34.5718 39.7067 40.0668 -5.06722 14.7699 1.92827 +4936 4 34.1159 40.1215 40.7935 -0.0189783 27.8984 7.01187 +4937 4 34.2456 38.8495 40.221 -5.22714 -44.7262 -10.8544 +4938 6 20.1936 32.176 34.4055 -22.5016 27.7868 41.3602 +4939 4 19.6673 32.7687 35.0502 14.2298 -29.0143 -30.198 +4940 4 21.0584 32.1328 34.8407 -2.28869 -2.39527 -4.5293 +4941 6 19.3074 38.5208 11.8317 17.689 14.4135 -2.63233 +4942 4 19.236 37.5914 12.0232 -0.177798 -10.0936 4.99209 +4943 4 20.0172 38.8749 12.4245 -13.7536 -7.85063 -8.99287 +4944 6 6.52955 13.5023 26.836 -16.6143 37.6784 -17.6139 +4945 4 6.084 14.0762 26.1427 18.8957 -21.2062 24.9102 +4946 4 6.49663 12.6281 26.4634 0.197125 -15.4908 -4.14034 +4947 6 23.5952 31.5638 33.3318 1.16311 -12.5666 -5.83621 +4948 4 23.0836 31.562 34.1475 0.610672 3.97154 0.891929 +4949 4 23.5328 30.6432 33.0053 1.46337 8.27478 -1.79938 +4950 6 41.0778 31.9114 16.1974 16.3032 -14.6541 -18.8682 +4951 4 41.8878 32.072 16.7344 -12.1593 -9.44827 -16.6375 +4952 4 41.2894 31.3264 15.4036 6.53327 16.9697 25.199 +4953 6 31.7476 18.8699 19.3483 9.2825 22.1595 5.37598 +4954 4 32.0642 19.7361 19.7036 -9.20895 -19.367 -8.68372 +4955 4 31.4026 18.3831 20.1168 1.10858 -0.37958 -4.48043 +4956 6 10.4875 4.12209 19.3444 6.70816 11.4672 -10.0773 +4957 4 9.70261 4.48263 18.8666 20.7562 -4.21822 -0.723312 +4958 4 11.3166 4.33216 18.8218 -27.5212 -3.06207 15.0001 +4959 6 1.37991 32.4635 19.2846 24.7257 -29.6508 -15.3303 +4960 4 1.97113 31.6954 19.1311 -3.90248 7.07021 19.3035 +4961 4 1.16609 32.6455 18.3731 -9.24935 13.5936 -9.63824 +4962 6 42.8716 16.8513 24.9892 37.8526 -21.8211 -51.5646 +4963 4 42.4398 17.6894 25.0051 -12.6784 17.6471 3.13223 +4964 4 43.4179 16.871 24.1222 -26.4831 0.994324 39.976 +4965 6 45.3183 19.1979 4.10041 6.37956 15.045 3.35342 +4966 4 46.1127 19.7887 4.04575 -15.2131 -7.48775 2.85843 +4967 4 44.6191 19.6898 4.58798 10.0124 -1.75765 -5.61527 +4968 6 29.1291 19.8804 35.7574 13.154 -41.1853 -12.3735 +4969 4 28.6049 20.2559 36.4387 -19.4183 16.2678 16.1743 +4970 4 29.3151 20.5439 35.0927 -1.78114 11.3903 -2.63997 +4971 6 31.9353 21.8377 19.6787 8.2762 14.7684 -3.54893 +4972 4 32.7301 21.8918 19.0885 -22.5823 -4.29925 15.9785 +4973 4 31.6692 22.7774 19.8195 3.83825 -20.8185 -1.08359 +4974 6 39.1936 8.26228 18.8336 -23.7578 16.4079 -2.4793 +4975 4 38.9784 7.343 18.63 -1.41923 -3.63173 -0.882922 +4976 4 38.3593 8.77699 18.6285 24.7505 -17.6369 4.60834 +4977 6 33.27 13.2649 41.2621 -10.1289 -28.0457 11.6457 +4978 4 32.3532 13.5818 41.1472 2.43324 -1.71459 -0.314725 +4979 4 33.2053 12.355 41.6729 1.3348 20.3333 -9.56947 +4980 6 5.93721 29.5458 35.7995 -7.4397 -15.3695 -5.23966 +4981 4 6.3797 30.3135 36.1022 6.42857 23.5026 12.0451 +4982 4 6.51225 29.246 35.0987 1.02237 -6.8727 -9.18458 +4983 6 13.023 34.1764 31.9266 -10.1581 -4.84889 27.419 +4984 4 13.003 33.3874 31.3637 -4.82745 -5.23795 6.11925 +4985 4 12.6053 33.9771 32.8123 10.4055 -1.49763 -26.3146 +4986 6 33.9757 21.8032 17.9969 16.1152 -19.1834 -4.43927 +4987 4 34.6651 21.0941 18.0436 -13.0194 10.1005 -1.31384 +4988 4 34.4424 22.6001 17.7557 11.611 10.6919 -5.33679 +4989 6 35.9777 41.3398 18.1614 -6.56463 -6.11943 -26.9477 +4990 4 35.8856 41.423 17.1648 6.35377 -3.40276 32.4743 +4991 4 36.5823 0.128109 18.4064 3.22136 6.47441 1.04719 +4992 6 34.856 37.6452 30.5972 -0.647303 3.94572 7.36538 +4993 4 35.2577 36.9607 30.0196 0.445186 1.06156 15.4535 +4994 4 34.8848 37.3986 31.5588 5.49281 -5.52744 -23.9922 +4995 6 25.9972 34.4216 4.68589 -10.7784 -9.94602 -21.2075 +4996 4 25.3582 34.53 5.39473 2.66172 5.48603 12.8385 +4997 4 26.8259 34.8497 4.89674 4.47855 8.12742 13.9663 +4998 6 19.0606 33.5662 1.31783 4.31184 23.0948 -29.5486 +4999 4 19.7493 33.0549 1.74461 7.17592 -5.61608 3.87291 +5000 4 19.5019 34.1007 0.592753 -8.94353 -18.7796 23.9626 +5001 6 25.2721 8.22916 8.60038 8.3672 -6.50911 13.4278 +5002 4 25.4774 8.1828 9.55838 -2.37789 7.03817 -10.0574 +5003 4 25.4001 9.14285 8.30246 -0.229164 -0.61302 1.82749 +5004 6 12.8408 19.6874 13.0432 23.1779 -10.767 -3.57874 +5005 4 11.9236 19.9359 13.0109 -16.1394 8.08564 -1.3752 +5006 4 13.3549 20.4875 12.8299 -11.6819 -5.55115 1.76181 +5007 6 53.3458 11.4322 5.81729 13.7919 -26.0181 10.511 +5008 4 53.941 11.999 6.3288 -5.2171 7.54934 -1.97002 +5009 4 52.6156 11.905 5.44666 -11.025 16.6744 -4.72885 +5010 6 9.84401 16.0447 31.1965 1.52473 25.7097 1.4485 +5011 4 9.0725 15.75 30.7245 -12.2986 -10.5074 -10.4763 +5012 4 9.76401 17.0228 31.1974 4.09395 -10.8484 3.46066 +5013 6 25.4337 20.2897 3.31222 -0.0744965 -16.6885 15.2888 +5014 4 25.4502 20.7681 4.1742 1.29774 3.58896 -22.0188 +5015 4 25.617 20.9088 2.59036 0.892976 4.59184 10.0233 +5016 6 20.7687 8.19442 15.6442 -13.8219 -45.5838 -0.24202 +5017 4 20.3131 8.5145 16.4113 -6.16339 18.6345 13.1662 +5018 4 20.3525 7.29833 15.5772 17.5129 18.5489 -8.91575 +5019 6 37.6537 8.61162 9.99803 6.38032 -10.5281 17.8344 +5020 4 37.9174 7.70722 10.2264 -2.01487 8.44182 4.78342 +5021 4 37.3414 8.51532 9.10193 -3.86116 3.7435 -6.65528 +5022 6 50.6588 4.51187 24.2729 -10.1552 -3.70856 6.87258 +5023 4 49.9071 3.88527 24.1971 13.583 4.61791 0.248303 +5024 4 51.4381 4.036 24.5943 -3.42543 -3.47462 2.6777 +5025 6 20.1632 24.8244 34.8962 -12.0105 28.899 -22.2545 +5026 4 19.9486 25.4522 34.1467 5.29317 -18.0262 19.0072 +5027 4 20.331 23.9626 34.5117 -0.31696 -10.3492 -2.27521 +5028 6 30.5785 22.522 11.2467 -2.76969 13.8933 23.9619 +5029 4 31.2526 22.1243 10.7257 13.2932 -13.8734 -17.1472 +5030 4 31.019 23.338 11.5119 -11.6942 5.7798 2.38886 +5031 6 17.322 40.803 8.03266 14.2969 -15.2802 9.14469 +5032 4 17.3696 39.9923 8.55945 -20.3131 5.85274 7.92005 +5033 4 18.1352 40.6655 7.5489 4.4024 9.10004 -19.1526 +5034 6 23.9661 41.0457 26.0803 21.1205 -0.428792 10.5169 +5035 4 24.3123 40.6207 25.2948 17.4674 -5.32369 -4.96192 +5036 4 23.0464 41.0448 25.8953 -36.0489 4.67224 4.09659 +5037 6 9.79449 25.5813 27.216 11.7002 -20.4303 -20.1428 +5038 4 10.1564 25.0129 26.491 -8.57195 17.3601 17.171 +5039 4 10.1924 25.2359 28.0288 -3.53182 0.239058 0.558234 +5040 6 35.2535 29.8267 24.7533 16.8399 6.514 6.92542 +5041 4 34.3962 29.6585 24.3475 -6.29365 6.70405 -5.90439 +5042 4 35.51 30.7547 24.57 -10.2352 -8.20594 -2.77553 +5043 6 2.14051 4.25227 10.5512 -4.35014 2.09559 7.87868 +5044 4 1.87018 4.24401 11.51 4.03105 2.56783 -22.6964 +5045 4 1.48695 4.75313 10.0317 0.0426026 -1.98947 12.7879 +5046 6 43.1755 3.92129 23.5016 -16.6861 -14.9885 0.818311 +5047 4 43.8939 4.14262 22.9078 7.68421 2.83398 -7.81803 +5048 4 42.5577 3.34913 22.9937 11.3891 7.34243 2.48813 +5049 6 18.8996 22.6297 2.43765 22.7339 -13.1014 -2.24121 +5050 4 19.79 22.181 2.40524 -25.7911 11.1615 4.63986 +5051 4 18.7139 22.8085 3.37028 4.18935 -2.21949 -1.21374 +5052 6 20.4908 18.9405 41.5599 0.284845 -17.4141 21.8797 +5053 4 20.1374 18.6064 0.533469 2.69626 22.1818 -33.2143 +5054 4 19.9839 19.6587 41.147 -4.56676 -6.01516 12.1125 +5055 6 26.4163 7.55623 29.1338 1.47231 -3.25042 -11.8229 +5056 4 25.7099 7.08251 28.6481 8.40182 7.03804 13.9135 +5057 4 27.0821 7.71224 28.4448 -4.02075 -2.1597 11.7889 +5058 6 25.6465 35.5679 33.7595 -11.9902 -19.4032 2.16293 +5059 4 26.3374 36.2384 33.6103 2.60319 -14.9989 -6.30077 +5060 4 25.8315 34.6987 33.2841 2.54327 33.8846 12.2934 +5061 6 24.8333 0.493635 8.41989 34.5336 11.5552 47.2955 +5062 4 25.5249 0.302877 9.1499 -35.8013 6.01564 -39.2036 +5063 4 24.7614 41.6068 7.91956 0.436288 -16.6888 -13.1367 +5064 6 17.008 17.3182 3.45493 -26.2706 15.7324 15.4846 +5065 4 16.2426 17.9829 3.53843 29.8189 -30.5055 4.13684 +5066 4 17.1653 16.9244 4.35506 -11.2277 16.1793 -19.3505 +5067 6 40.1827 32.1035 19.3506 13.0539 -5.95213 0.358733 +5068 4 39.8335 31.2604 19.604 -25.4023 -11.2285 12.0125 +5069 4 40.9513 31.7409 18.9215 18.5667 14.352 -9.19942 +5070 6 23.3808 26.7171 6.31746 29.0762 21.4976 14.3842 +5071 4 24.13 27.3908 6.46801 -30.1018 -19.5893 -7.69607 +5072 4 22.7349 27.0723 5.68536 3.11778 6.18165 -0.6273 +5073 6 28.6527 28.5112 1.41186 -10.6623 -30.4119 4.69741 +5074 4 28.683 29.4458 1.20631 15.125 4.74584 -7.70298 +5075 4 29.5288 28.0803 1.2704 -12.115 26.7011 1.44139 +5076 6 12.0438 6.3157 14.0384 -8.70244 -3.06108 -4.52058 +5077 4 11.2798 6.1721 13.4181 27.4537 -0.215786 8.28745 +5078 4 12.8925 6.19521 13.5554 -16.057 2.9292 1.41242 +5079 6 20.1243 33.7022 32.0954 -30.4257 7.53408 -8.19993 +5080 4 20.1371 33.1054 32.8412 7.6416 -5.80656 10.7415 +5081 4 21.0197 33.8732 31.8382 18.9224 -1.8204 -0.321518 +5082 6 12.0625 33.3632 34.5388 -0.325915 -41.4281 -23.9157 +5083 4 11.5602 33.8727 35.1697 -10.674 0.646784 10.687 +5084 4 11.6234 32.4653 34.3673 14.5179 34.5198 8.14895 +5085 6 6.00279 22.2605 25.0501 2.06163 -11.5991 79.3474 +5086 4 5.88194 22.3996 24.153 -16.4068 14.8809 -57.8418 +5087 4 5.25089 22.6367 25.5854 16.5977 -6.05374 -22.2773 +5088 6 28.8802 9.48792 11.0269 30.0757 -27.8021 5.60101 +5089 4 29.142 10.167 11.6644 -15.2392 1.2069 -12.766 +5090 4 28.0854 9.70897 10.5587 -15.7703 15.13 -3.00542 +5091 6 25.9783 31.1564 24.8742 0.212243 -23.2246 11.0271 +5092 4 26.2703 31.9474 24.4305 5.78101 9.73635 -10.8861 +5093 4 26.5948 30.4205 24.6499 -9.08002 14.2421 1.82694 +5094 6 17.4069 22.6321 26.9528 -11.8732 29.0046 13.506 +5095 4 17.1509 23.4374 27.5137 11.798 -28.7792 -23.9739 +5096 4 17.5283 21.9112 27.5803 0.671776 -8.09241 2.21186 +5097 6 30.9731 17.6144 1.64569 13.582 26.8251 31.1357 +5098 4 30.2123 17.6859 1.07719 -13.0538 -2.75682 -13.3747 +5099 4 31.0067 18.4528 2.19078 1.05257 -25.2161 -14.5596 +5100 6 35.2833 9.73343 11.2271 -16.277 -4.62114 -26.0747 +5101 4 34.627 9.45499 10.5137 29.3374 5.62349 25.4867 +5102 4 36.1567 9.37366 10.9701 -6.28276 0.375521 -3.01301 +5103 6 12.0057 10.8077 4.27601 -12.2512 -1.40581 -7.43609 +5104 4 11.4458 10.5898 5.05281 2.39288 0.24657 -15.6405 +5105 4 11.51 10.5288 3.46435 7.55978 2.35404 20.8087 +5106 6 52.9546 23.1284 7.66438 3.19212 11.9041 -9.13647 +5107 4 53.8155 23.0936 7.22037 1.72331 -6.21969 -0.472682 +5108 4 52.7997 24.0739 7.82392 -0.633169 -8.94194 3.43433 +5109 6 27.374 5.80114 23.1096 7.51778 12.7335 11.6917 +5110 4 28.1753 5.52132 23.6349 -22.415 18.9583 -13.4562 +5111 4 27.3645 6.79042 22.9959 5.3793 -33.2455 5.89418 +5112 6 22.7689 37.6996 15.5372 -5.91943 -7.67105 33.7333 +5113 4 22.8436 37.842 14.6084 2.14719 5.97904 -25.5056 +5114 4 23.2999 36.9284 15.7907 -0.822855 1.46565 -2.93441 +5115 6 30.5901 30.1355 39.7465 -8.92084 9.99629 -19.6672 +5116 4 30.0839 29.6315 39.0953 -1.54922 -9.94816 6.16305 +5117 4 30.5761 31.0154 39.3281 8.00114 -4.73058 9.29019 +5118 6 26.5152 14.8694 29.9646 3.93344 -0.205179 -3.29595 +5119 4 25.7559 15.3094 30.3103 -24.5604 12.1261 -1.41502 +5120 4 27.0839 14.9289 30.718 22.1413 -5.57177 12.178 +5121 6 9.52543 19.5487 37.4182 -4.93509 -3.75546 7.04348 +5122 4 8.56858 19.5373 37.6772 20.7537 10.8584 -9.00922 +5123 4 9.7741 20.4052 37.0166 -14.5013 -9.56436 9.93265 +5124 6 0.91928 14.8658 2.69601 -17.5095 9.99019 63.3715 +5125 4 1.47581 15.1737 2.02419 28.2707 8.36374 -43.6031 +5126 4 1.18821 15.4309 3.47389 -7.04008 -21.0896 -18.5042 +5127 6 46.427 27.1287 41.5945 43.2461 -1.33556 -25.8044 +5128 4 47.402 27.2052 41.2817 -46.4011 -2.64418 15.4668 +5129 4 46.0299 26.5803 40.8989 0.996959 5.24299 8.87294 +5130 6 47.678 23.0562 21.3872 5.44089 38.3346 6.01366 +5131 4 46.9403 23.2179 20.8133 -13.997 9.90145 -6.64011 +5132 4 47.7418 22.1285 21.385 8.56341 -43.7487 4.99103 +5133 6 39.8587 22.235 3.08723 2.37939 -15.5871 -9.21378 +5134 4 39.0088 22.2526 3.53641 -4.44104 7.43329 4.08383 +5135 4 39.9535 21.2857 2.86173 -0.917299 22.2801 6.61021 +5136 6 14.9853 14.9328 33.4647 9.90785 18.6887 5.96998 +5137 4 15.4024 15.8269 33.5858 -13.0369 -24.3412 -0.758701 +5138 4 14.5599 14.6915 34.3048 3.28451 6.61064 -6.43534 +5139 6 27.3302 11.4834 31.9317 -27.4366 -15.9755 21.8219 +5140 4 26.9982 12.0952 32.5883 -9.79098 -5.70708 8.51591 +5141 4 28.0752 11.9422 31.6406 46.9031 18.536 -28.2392 +5142 6 36.7579 7.97089 7.62034 -1.24967 -18.9477 -14.6485 +5143 4 35.954 7.42009 7.70022 6.4697 6.94413 -3.0671 +5144 4 37.4142 7.36122 7.22008 -3.07725 6.9494 1.66736 +5145 6 49.4451 9.66335 18.2174 -4.20907 -17.0946 -5.32386 +5146 4 50.1075 10.0642 17.6138 -11.2883 10.4151 20.0604 +5147 4 49.0937 10.2089 18.9473 16.8995 10.9543 -13.1485 +5148 6 27.0353 33.866 10.7555 -3.61813 20.4819 39.0174 +5149 4 27.1089 33.3944 9.9425 -11.0368 -7.55411 -28.9907 +5150 4 26.1735 34.332 10.8422 4.28798 -12.7598 -13.2634 +5151 6 11.1949 37.4624 6.84871 0.36549 -16.8746 15.3404 +5152 4 10.8648 38.3395 6.66289 0.465253 11.7734 -2.90488 +5153 4 12.1583 37.5341 6.85599 1.64848 0.115814 -1.2743 +5154 6 19.2537 19.4156 21.9114 -15.7985 8.22585 33.6704 +5155 4 18.5515 19.3251 21.2863 -16.3583 -5.26309 -15.3133 +5156 4 20.0646 19.323 21.4355 25.7859 -3.53787 -14.4318 +5157 6 54.4972 2.91444 22.5674 41.6328 11.7794 25.4635 +5158 4 54.323 3.09449 21.6644 -16.7292 4.15243 -34.296 +5159 4 0.405558 3.31869 22.7045 -24.6299 -12.807 4.19326 +5160 6 45.0583 10.8549 24.2301 5.83399 20.0221 21.0618 +5161 4 44.4296 11.5751 24.1426 -7.03973 -3.51443 -9.4179 +5162 4 45.6095 11.2138 24.9523 4.1225 -19.1196 -10.3672 +5163 6 14.387 34.402 24.7643 -0.614961 -5.50567 -8.46915 +5164 4 14.802 35.2302 25.0278 -0.621724 2.17228 4.67692 +5165 4 14.8142 34.1913 23.9221 -0.527667 -3.77388 -2.27373 +5166 6 50.586 17.557 4.30707 17.1275 -18.9627 18.6811 +5167 4 51.3126 17.9927 4.759 8.45418 -3.82203 7.11351 +5168 4 50.1863 18.2804 3.88376 -26.598 27.5468 -24.7799 +5169 6 14.9317 33.3337 34.1113 -12.3404 20.8418 56.9019 +5170 4 15.0455 32.9404 33.2912 5.44957 -23.8922 -53.334 +5171 4 14.0148 33.1563 34.3942 8.12215 6.97131 -5.23034 +5172 6 20.8706 33.5768 38.9143 15.1188 7.04694 -15.6549 +5173 4 20.7999 34.008 39.7578 -2.44584 7.66125 17.1111 +5174 4 20.3826 32.7659 38.9944 -10.1095 -18.4284 -0.973943 +5175 6 7.78494 4.73961 26.7587 18.7098 -5.63937 13.378 +5176 4 7.2181 5.0845 27.4506 -5.7435 6.37459 2.19378 +5177 4 7.246 4.75931 25.9687 -5.82922 -1.99593 -5.70414 +5178 6 9.28281 21.4851 22.3014 51.087 14.0475 -25.6174 +5179 4 8.74732 21.9732 21.6886 -31.0609 5.1079 -5.58489 +5180 4 10.1706 21.7227 21.8793 -22.1752 -18.3044 28.8298 +5181 6 20.5441 38.2146 8.8638 -2.83914 11.917 26.817 +5182 4 20.3663 38.6401 9.7626 4.81036 -21.6973 -30.7816 +5183 4 20.4013 37.2533 8.94236 -1.07384 9.24152 7.62946 +5184 6 30.1053 39.0795 30.7451 -13.6764 41.2724 28.6819 +5185 4 30.3998 39.946 31.2193 -9.10868 -42.8123 -24.766 +5186 4 29.1169 39.0706 30.8728 28.3121 -0.882933 -5.94109 +5187 6 16.0486 22.0268 24.5039 34.2787 3.60452 0.906339 +5188 4 16.7735 22.0671 23.8432 -14.3833 -3.87047 -0.289875 +5189 4 16.5419 22.3002 25.3044 -14.2176 -3.36187 3.5873 +5190 6 5.74232 29.2062 14.4594 -18.34 10.8061 -32.1404 +5191 4 6.48422 28.7094 14.7814 11.5218 -3.49899 17.506 +5192 4 5.24211 29.6259 15.1721 5.10135 -5.91064 9.04276 +5193 6 28.0673 3.08827 25.2267 -6.08854 1.42804 12.0746 +5194 4 28.6661 3.71086 24.7756 -7.19123 -0.840207 10.3279 +5195 4 27.7106 3.5203 26.0449 13.0908 -0.523763 -20.3567 +5196 6 45.9319 29.2971 31.4223 -7.33073 21.7818 28.5056 +5197 4 45.7264 28.738 30.6765 -12.0419 -4.51403 -16.7723 +5198 4 45.1872 29.9464 31.611 20.2512 -24.9239 -13.0948 +5199 6 11.2178 22.8398 36.7928 3.83605 7.6889 -19.1741 +5200 4 10.7288 23.4227 36.1801 1.54849 -6.36416 6.79315 +5201 4 12.0227 22.5824 36.3 -5.92076 -0.954096 11.0422 +5202 6 18.9236 40.1387 39.9284 -8.72712 -15.4473 12.674 +5203 4 19.137 39.1923 39.9727 -1.01676 1.76774 -7.47997 +5204 4 18.926 40.4024 40.8597 -1.95632 5.76083 -1.10583 +5205 6 23.5567 26.0801 21.2876 -20.8354 -5.58511 20.4095 +5206 4 22.8283 26.6117 20.9473 7.44123 1.31497 -7.03875 +5207 4 23.1869 25.6705 22.0991 12.7429 3.57595 -14.6326 +5208 6 16.8309 5.38685 15.8596 17.5735 -24.6285 20.3591 +5209 4 16.4468 5.29371 14.9868 -10.6119 14.9975 -0.930521 +5210 4 16.6163 6.1995 16.3389 -7.69088 7.65746 -13.895 +5211 6 12.049 26.6129 14.9962 1.83385 5.07399 -16.0821 +5212 4 11.6864 25.936 15.5307 6.55853 -24.3886 27.1256 +5213 4 11.2609 26.839 14.5085 -0.894459 16.8406 -16.785 +5214 6 14.3334 41.4222 2.37421 26.0216 21.5484 -18.2857 +5215 4 13.7051 40.9662 2.90199 -22.7144 -12.1023 21.977 +5216 4 14.3738 0.426145 2.71152 -4.41702 -11.6567 2.07407 +5217 6 50.4009 35.8582 9.31454 24.1561 17.2373 -12.1424 +5218 4 50.8168 35.8748 8.42953 -10.1576 -5.67977 3.83986 +5219 4 50.8977 36.5714 9.7704 -11.7974 -14.2445 3.10197 +5220 6 11.3695 22.6672 26.8678 6.20997 3.92483 11.2558 +5221 4 12.2048 22.3333 26.5164 -4.88328 -1.76893 -0.685046 +5222 4 10.6892 22.391 26.2565 -8.40373 -4.36232 -8.95219 +5223 6 8.45148 34.5593 21.2814 -25.9919 -59.0281 13.1791 +5224 4 8.04792 35.0446 21.9998 -0.548909 12.0582 7.93151 +5225 4 8.02348 33.6171 21.3881 27.3669 48.26 -12.6189 +5226 6 9.41918 8.68911 24.4735 -32.1109 22.232 -11.1027 +5227 4 8.45415 8.80658 24.2608 22.5553 -3.45738 3.03744 +5228 4 9.54271 9.26889 25.2379 6.1219 4.18012 4.13063 +5229 6 32.6166 22.3351 34.507 3.90791 9.0503 -27.7323 +5230 4 32.5036 23.1955 34.0662 0.599489 -5.17288 -1.28756 +5231 4 32.8196 22.6091 35.3861 6.87298 3.84758 30.2519 +5232 6 26.7427 26.1702 7.11338 18.0622 8.0778 -11.4877 +5233 4 26.0574 25.7087 7.60312 -9.51312 -3.43645 7.19196 +5234 4 26.4504 27.0916 6.97179 -2.60416 -16.0173 4.37043 +5235 6 33.9976 11.9299 3.97475 -1.16308 1.75568 6.69865 +5236 4 33.7915 11.6388 4.87314 3.4696 4.99202 0.68255 +5237 4 33.8545 12.8906 3.99294 -0.306808 -3.71184 -1.40707 +5238 6 21.4819 20.9256 37.2108 -8.76322 20.972 13.918 +5239 4 22.36 21.3309 37.2026 5.25525 -6.97128 0.105034 +5240 4 21.5739 19.9858 37.0637 7.9716 -15.2147 -3.23728 +5241 6 18.467 41.0278 0.654954 -19.554 -29.5721 -12.8619 +5242 4 17.5024 41.1258 0.530294 8.77033 6.01734 2.0842 +5243 4 18.8042 41.8885 0.845086 4.40915 26.8371 2.49279 +5244 6 41.3548 41.7118 25.1844 12.9409 14.5374 -0.392323 +5245 4 40.9222 40.8883 25.4041 -6.90081 -12.2223 3.22908 +5246 4 41.5202 41.6634 24.2378 -1.56977 -0.361026 -1.444 +5247 6 27.6369 28.1312 3.93858 39.9773 31.9241 -60.8173 +5248 4 27.7577 28.1455 2.91253 -1.05119 3.80663 52.0412 +5249 4 26.945 27.5412 4.09124 -36.8498 -31.9254 8.70709 +5250 6 18.2839 10.5111 31.4966 0.533258 -0.0130678 0.979798 +5251 4 17.4029 10.1636 31.5665 -10.6602 -13.9647 -0.00296819 +5252 4 18.1106 11.4466 31.5267 10.9856 11.4938 1.12981 +5253 6 11.3036 37.9694 14.764 4.77413 -10.0896 11.5971 +5254 4 10.7874 37.239 14.4221 -9.53089 5.23111 -9.63971 +5255 4 11.7579 37.5414 15.5118 -2.30342 16.6377 -5.07599 +5256 6 0.816524 18.1414 27.5647 20.1272 -0.3628 -0.469578 +5257 4 0.17179 17.4415 27.469 -11.396 -5.37013 -1.78049 +5258 4 1.63281 17.6507 27.785 -7.45447 11.2502 -1.88757 +5259 6 36.8008 10.7378 20.295 8.4208 9.86458 8.47872 +5260 4 36.1948 10.0642 20.0001 -9.44027 -8.16387 -5.04241 +5261 4 36.5983 10.8279 21.2363 1.65531 0.40354 2.85938 +5262 6 47.4201 25.5213 8.04394 8.74054 5.57223 -13.14 +5263 4 47.3566 25.6372 7.0634 -2.71671 -4.96685 23.4826 +5264 4 46.5708 25.2582 8.40304 -6.39129 0.734124 -5.55138 +5265 6 13.9238 35.1275 16.0037 32.5083 18.1998 3.59786 +5266 4 13.2022 34.5755 16.1957 -32.489 -30.3694 18.6715 +5267 4 13.7597 35.4303 15.121 4.25156 9.41728 -20.5426 +5268 6 29.562 35.3734 16.1776 -35.0835 -2.07929 -8.00281 +5269 4 30.2224 34.9599 16.7245 13.9673 -5.91711 9.2078 +5270 4 28.7051 34.8863 16.2926 25.5199 12.926 -4.35301 +5271 6 29.4722 25.8866 32.4187 14.354 2.72026 -23.1845 +5272 4 28.9025 25.7608 33.1796 -14.4011 -9.23541 2.43376 +5273 4 29.1922 25.3818 31.6086 -3.9853 6.0929 23.1903 +5274 6 24.1343 2.13601 25.4438 45.8363 12.8335 -27.0328 +5275 4 24.6226 2.81425 24.8647 -23.4035 -21.9591 22.2831 +5276 4 24.7019 1.32842 25.3981 -18.0817 13.4017 1.18969 +5277 6 4.54354 34.4275 19.14 11.1292 -12.0398 21.377 +5278 4 4.4735 34.5954 18.1883 -15.738 1.03246 1.7136 +5279 4 3.71635 34.4131 19.6775 9.89222 2.06937 -18.6971 +5280 6 10.1248 17.2257 14.3121 -1.66581 -5.60367 -9.60454 +5281 4 10.2583 17.5937 15.1679 8.8306 2.43924 21.0325 +5282 4 9.4989 17.8227 13.9164 -6.75609 1.38519 -13.487 +5283 6 21.4392 41.7587 34.6855 22.2624 7.769 -11.2018 +5284 4 21.5032 41.1211 35.405 -13.4071 -7.19641 7.36579 +5285 4 20.544 -0.0182627 34.3462 -4.72666 -12.2957 11.4101 +5286 6 36.1543 24.108 12.5954 -4.82194 -9.49577 -8.67068 +5287 4 35.691 23.694 13.3698 5.25066 1.62288 -23.6525 +5288 4 35.776 23.8018 11.7194 2.97337 4.42231 26.8685 +5289 6 49.5838 18.601 19.9434 7.37368 0.836531 -4.03301 +5290 4 50.0063 19.3607 19.4891 -2.40205 -12.3461 5.19746 +5291 4 50.2865 17.9356 20.0577 -3.44895 8.52353 -2.14521 +5292 6 1.26001 7.05318 14.4907 38.3056 -26.8237 -27.7837 +5293 4 1.8201 6.82299 13.6677 -23.9217 11.4061 34.9177 +5294 4 1.48256 6.35829 15.148 -4.21477 12.5307 -9.57675 +5295 6 12.7431 22.7759 31.2417 -21.5742 -17.6245 -17.2109 +5296 4 12.7068 22.0167 30.6251 -0.189583 12.5272 11.0438 +5297 4 13.6543 23.0267 31.2833 20.8009 4.17698 1.04357 +5298 6 8.18693 18.6259 27.8062 12.2535 -2.56913 -7.18349 +5299 4 8.40416 17.6764 27.919 2.05523 15.8207 -2.89848 +5300 4 8.90605 19.0032 27.258 -7.77238 -10.2714 7.52916 +5301 6 52.132 28.0244 15.3085 -5.0475 -8.46487 8.97907 +5302 4 52.2845 27.4141 14.5747 1.7297 4.34316 -0.517396 +5303 4 52.1194 28.9169 14.9336 2.1814 -6.82244 -4.33507 +5304 6 52.6909 21.916 10.0977 -8.33066 3.09691 2.06611 +5305 4 53.4463 22.3007 10.5387 10.5159 5.84972 4.87058 +5306 4 52.7807 22.2562 9.19728 -3.40401 -0.944397 -1.81328 +5307 6 22.3502 5.78024 2.67711 -1.19821 4.70475 8.9403 +5308 4 22.3462 5.61537 3.63751 1.98719 -8.03511 -7.01348 +5309 4 22.5962 4.95479 2.25163 2.53332 -12.0932 -0.158426 +5310 6 15.4205 16.2192 21.8867 5.02822 24.0999 -40.4778 +5311 4 14.4784 16.2102 22.0595 -10.022 -3.20892 10.2198 +5312 4 15.4767 16.6809 20.9929 2.09736 -16.6333 30.6862 +5313 6 28.7089 41.2927 33.91 5.52796 3.54283 5.25404 +5314 4 28.727 40.4953 34.4564 -2.79359 -2.24742 -0.170863 +5315 4 27.7951 41.4466 33.6263 4.57527 -2.88437 3.84631 +5316 6 9.01739 31.2727 18.2059 -18.1749 -3.84142 11.7815 +5317 4 8.98151 32.2312 18.3694 0.025829 -3.44513 1.18933 +5318 4 8.52849 30.7949 18.9304 13.8496 11.5721 -17.6376 +5319 6 20.5529 20.3981 18.1799 -10.2473 -3.12886 -8.71499 +5320 4 21.0329 20.6151 18.9854 0.125323 4.65459 7.73128 +5321 4 19.8496 21.0773 18.075 13.4895 -10.4913 3.92819 +5322 6 53.9703 14.7072 37.8312 5.01214 -4.5628 8.74013 +5323 4 53.4666 15.4974 37.9319 -5.56379 24.6001 14.4542 +5324 4 53.6093 14.375 37.0321 1.20033 -18.5897 -21.23 +5325 6 28.9035 15.3885 18.8586 45.4636 -15.1916 -0.680493 +5326 4 29.8469 15.0873 18.5932 -41.6456 12.1347 6.71251 +5327 4 28.9115 15.3505 19.8299 -3.5302 1.25595 -2.12016 +5328 6 2.00256 25.8212 18.9096 3.72723 11.471 14.7099 +5329 4 2.26458 26.6216 18.4327 2.14682 1.88771 -0.892997 +5330 4 1.76414 25.179 18.2501 -5.23937 -11.562 -15.1322 +5331 6 53.2507 40.704 24.2965 8.91441 12.4597 1.37217 +5332 4 53.4683 39.7911 24.0958 -2.511 -10.6834 -0.444896 +5333 4 54.079 41.1598 24.0633 -8.96863 1.63956 3.52407 +5334 6 47.5231 32.0042 22.8531 -14.3462 4.46803 -6.08063 +5335 4 47.3408 32.7709 23.4273 6.00779 -4.56073 2.25025 +5336 4 48.2766 31.5253 23.2067 4.67997 4.39959 7.43042 +5337 6 24.6197 26.1463 33.0089 -12.4366 -5.18424 3.68853 +5338 4 24.4183 25.6868 33.835 -4.3875 -0.159577 -1.83724 +5339 4 25.4547 26.5812 33.1385 10.0429 5.3772 -3.83199 +5340 6 21.3442 17.0884 39.4824 -9.75867 4.42788 -12.86 +5341 4 22.0786 16.6105 39.8509 9.0034 -0.419098 8.66004 +5342 4 20.9617 17.649 40.1682 3.71874 -0.284678 5.70811 +5343 6 11.0324 40.4486 17.0358 15.7971 -30.8577 -26.0801 +5344 4 11.6842 41.1185 17.2103 4.65986 12.9737 2.4903 +5345 4 11.491 39.8695 16.3608 -26.1319 15.9634 25.4848 +5346 6 20.3416 21.2702 39.8615 -24.9835 10.9638 22.3655 +5347 4 20.689 20.9793 39.0389 13.9219 -9.37305 -28.7546 +5348 4 21.0638 21.2843 40.4958 4.25493 1.29328 -0.298347 +5349 6 2.11091 29.6941 22.5934 -5.9509 -23.8702 -11.6938 +5350 4 1.45034 28.9715 22.5035 1.67869 13.3355 3.97539 +5351 4 2.94117 29.2559 22.3631 0.0654014 9.01208 -1.60678 +5352 6 36.7558 30.2897 35.4506 24.3729 -18.3256 16.5828 +5353 4 36.1768 30.1398 36.2224 6.47664 5.98183 -7.75951 +5354 4 37.6324 29.8684 35.7011 -26.9845 14.5763 -5.36474 +5355 6 12.9471 4.31284 37.9204 -6.90268 -11.166 6.10722 +5356 4 12.3078 3.59731 38.1765 12.7034 25.1114 3.17689 +5357 4 12.7446 5.19856 38.3152 -2.40344 -19.0082 -2.01981 +5358 6 38.3332 5.26794 18.4655 -19.3496 19.9027 -29.1997 +5359 4 37.4721 5.17942 18.8804 2.72791 -1.29988 8.64573 +5360 4 39.0241 5.01488 19.0552 15.587 -10.1496 24.0772 +5361 6 10.4858 9.23289 21.7404 -25.2332 -4.10139 2.16313 +5362 4 10.1465 9.25623 22.657 12.6022 -3.18555 -3.91704 +5363 4 11.447 9.27854 21.7188 5.40032 0.87934 7.2107 +5364 6 0.505771 41.0407 17.3245 -0.427706 37.3637 0.906459 +5365 4 1.03474 40.3115 17.5973 10.8601 -24.0642 8.3812 +5366 4 1.07952 41.8285 17.484 -10.202 -14.0113 -5.73388 +5367 6 4.10283 5.07754 6.43738 -38.2782 -14.6693 -26.7901 +5368 4 4.80956 4.44559 6.48511 17.8781 -6.62955 4.00539 +5369 4 4.33824 5.81877 6.9517 16.1672 26.1823 21.8329 +5370 6 11.4353 25.4218 0.164599 -6.84764 4.42394 -1.26617 +5371 4 11.3082 26.3017 0.56247 4.23965 -3.25035 1.30302 +5372 4 12.32 25.1006 0.40702 -4.64442 7.63092 -0.276853 +5373 6 7.41885 21.5502 8.10769 10.495 -13.722 -26.2993 +5374 4 7.61759 21.2522 7.17802 -11.0567 9.56016 28.8323 +5375 4 8.26229 21.8826 8.44859 -7.90548 -1.09713 -4.6635 +5376 6 47.5869 16.3678 25.2584 -15.0789 15.5873 -32.807 +5377 4 46.6352 16.1327 25.0388 32.9447 8.00435 6.4503 +5378 4 47.9767 16.8704 24.4584 -11.2605 -20.3751 33.7323 +5379 6 30.9209 19.4939 39.8451 -11.8548 28.7526 -24.1689 +5380 4 31.8555 19.5183 40.0202 17.1254 -10.6903 10.4692 +5381 4 30.8076 20.3562 39.3598 -8.87252 -26.4956 11.5622 +5382 6 20.3775 24.0331 39.393 16.2123 32.2964 -6.62361 +5383 4 19.46 24.2872 39.3788 -17.3162 -0.971439 2.40317 +5384 4 20.4139 23.0995 39.5119 -7.32592 -29.4126 2.4841 +5385 6 45.906 21.2665 41.1719 -24.2736 -11.4825 -0.885762 +5386 4 46.5804 21.1569 41.8486 15.7955 10.6383 -1.5802 +5387 4 46.0859 21.9477 40.5132 15.7742 6.36757 6.57249 +5388 6 32.5682 28.1996 30.46 3.6658 -10.99 6.0107 +5389 4 32.938 27.299 30.6104 -6.7941 21.8776 -2.09353 +5390 4 33.2105 28.8285 30.8344 -2.85996 -8.65293 -4.24176 +5391 6 18.0144 1.30598 27.0418 -16.6632 -1.71712 -0.445992 +5392 4 17.1007 1.69106 27.0468 26.0213 -5.17059 4.63351 +5393 4 18.4653 1.60291 27.8546 -9.34219 2.14994 -8.02835 +5394 6 39.3706 24.9704 21.8707 -3.8719 -7.6304 -3.05608 +5395 4 39.4638 25.9303 22.0078 -2.06007 -5.24545 2.56571 +5396 4 38.5004 24.7369 22.2528 8.08795 9.92494 -4.1564 +5397 6 33.5838 21.3134 22.0984 8.18441 -4.13225 6.82001 +5398 4 32.7138 21.3502 21.682 2.4933 6.37883 -5.99313 +5399 4 34.1113 22.092 21.8324 -12.1677 -4.37971 -1.53996 +5400 6 40.113 14.9986 15.7558 -14.3933 -54.3129 -47.4443 +5401 4 39.335 14.6192 15.2293 31.4969 18.6384 20.9479 +5402 4 39.7901 15.7154 16.2477 -17.7573 36.9578 24.811 +5403 6 32.6916 17.9228 6.36161 -9.89813 9.73379 -21.0853 +5404 4 32.6423 17.3002 7.0662 1.70901 -17.6566 26.5232 +5405 4 32.2464 17.4542 5.63975 -0.790726 3.03073 -5.51736 +5406 6 50.4678 15.9334 31.144 -39.7004 -26.5385 31.9374 +5407 4 51.253 16.1743 30.7093 39.9028 11.8107 -24.2063 +5408 4 50.5343 14.9829 31.3801 -1.18751 16.0768 -7.78774 +5409 6 23.825 29.3336 31.6412 17.8706 -6.79638 -8.14744 +5410 4 23.7507 29.695 30.7549 -4.03414 2.57591 0.878238 +5411 4 24.7016 28.8907 31.6365 -14.4802 6.46497 6.02506 +5412 6 25.0497 41.6479 38.28 3.49637 2.98657 -6.73496 +5413 4 25.6848 41.2957 37.6072 -14.3525 10.6226 12.6055 +5414 4 24.5759 0.544247 37.957 10.7828 -14.7666 -1.7986 +5415 6 14.3338 25.4719 8.00129 -34.0608 -17.9542 9.33499 +5416 4 15.0375 25.807 7.49197 32.7442 17.1809 -19.3974 +5417 4 13.7504 25.049 7.33286 9.67269 6.09785 11.4563 +5418 6 17.2157 20.7463 5.33337 -33.6161 12.1619 46.6806 +5419 4 17.4746 20.2104 4.61987 19.6997 -12.8632 -39.6831 +5420 4 17.6039 21.6267 5.33982 9.69266 2.06371 -12.0346 +5421 6 18.8632 10.9532 23.7128 -6.45661 -28.7698 -18.1749 +5422 4 18.5024 10.4645 22.9505 4.54871 -4.25462 9.96764 +5423 4 18.7195 11.8343 23.4273 2.43458 32.1183 3.28403 +5424 6 7.79185 41.3929 11.0465 3.42517 6.73563 9.75028 +5425 4 8.03468 40.5075 11.3396 -5.29569 0.405018 -3.04036 +5426 4 8.54504 0.0288503 11.3371 -5.83581 0.184768 -2.76634 +5427 6 48.7029 23.1861 34.0656 -21.7207 -4.36764 -18.9996 +5428 4 48.0685 22.9631 33.3267 17.6914 7.49561 22.5851 +5429 4 49.5647 23.2306 33.645 9.38657 -0.0360042 -3.96825 +5430 6 53.7171 23.5593 15.3279 7.98903 18.1369 9.52531 +5431 4 53.9889 24.0987 14.5512 -16.5338 -16.4319 -0.0123194 +5432 4 53.1679 22.8017 15.1046 0.0193492 2.24596 -12.2178 +5433 6 22.2331 5.62812 9.84443 -1.57081 2.06392 2.32933 +5434 4 21.8309 4.81719 9.48029 9.17546 11.008 0.0652314 +5435 4 22.6135 6.1669 9.11622 -10.9942 -17.7486 8.8339 +5436 6 33.6597 8.39756 9.07438 12.888 -3.30103 7.28088 +5437 4 32.9598 8.97334 9.38893 -12.3292 7.33717 0.65351 +5438 4 33.4682 8.16911 8.16186 -5.09418 6.09353 -6.44604 +5439 6 47.3119 37.7194 20.3363 21.5156 22.744 3.03657 +5440 4 47.6473 37.5407 19.4464 -9.46862 -8.33692 4.35957 +5441 4 46.6883 37.0359 20.5464 -12.6113 -19.4741 -3.99141 +5442 6 30.8566 16.7294 10.6197 -45.1927 -36.7422 15.3603 +5443 4 30.4293 17.2093 11.3782 10.0419 -7.15869 -15.9692 +5444 4 30.3248 15.8445 10.5087 28.8517 44.18 3.4025 +5445 6 48.1145 27.7388 10.1259 3.61398 12.7601 13.975 +5446 4 49.0121 27.5791 10.4269 8.16567 7.74751 7.8449 +5447 4 47.9875 27.049 9.49259 -14.0608 -13.1923 -17.2023 +5448 6 27.3333 38.6223 25.6028 2.23096 -19.4823 3.9502 +5449 4 28.2552 38.3493 25.5855 1.31221 -11.4567 4.08925 +5450 4 27.4115 39.4856 25.2253 -6.51803 21.9055 -3.11379 +5451 6 33.3641 5.73966 21.4502 -17.8674 16.1521 -18.7045 +5452 4 32.7333 6.1391 20.8022 11.3762 -13.0233 18.1576 +5453 4 34.2053 6.04196 21.1266 17.0109 2.35293 -3.511 +5454 6 25.3113 5.14231 4.52483 0.627568 -0.448638 -4.7772 +5455 4 25.9311 5.01166 5.26368 -5.83567 -1.85096 0.781095 +5456 4 24.4169 4.85751 4.79359 12.9854 0.158453 3.02285 +5457 6 40.4761 35.641 19.148 -1.79116 -1.08437 4.96155 +5458 4 40.617 35.2798 20.0294 1.97887 -12.6912 2.42284 +5459 4 40.4316 36.5735 19.3404 -1.08207 12.5153 -8.94186 +5460 6 49.6577 30.6259 19.0198 10.1565 -2.14928 -32.2041 +5461 4 49.9169 29.8714 18.4657 1.24638 0.0316256 -4.24874 +5462 4 49.4705 30.2089 19.8368 -7.31172 -12.6811 36.7039 +5463 6 42.1447 28.3235 17.0346 32.2065 -21.7575 -5.76428 +5464 4 41.8825 28.1658 16.1189 -9.06503 7.62036 -2.3435 +5465 4 42.9622 27.7534 17.0825 -24.1402 18.2728 2.552 +5466 6 47.7039 24.5139 36.3396 16.4403 6.39896 -6.79461 +5467 4 46.9537 23.9582 36.5487 -4.01092 -10.0931 -4.11437 +5468 4 48.0889 24.2445 35.4833 -10.0455 -7.86437 4.89019 +5469 6 19.3463 26.9837 19.8062 -14.9609 -0.640093 12.1457 +5470 4 19.5138 26.0435 19.7544 7.81166 -12.6546 -12.1749 +5471 4 18.7209 27.0489 20.5386 2.91516 7.38851 -4.99075 +5472 6 47.0534 26.8134 37.524 14.5946 -27.4581 20.3182 +5473 4 46.5999 27.4025 36.9765 -27.9132 42.868 -22.1392 +5474 4 47.3287 26.1433 36.896 5.92816 -9.16339 3.59921 +5475 6 9.30604 24.6864 40.2824 32.5721 -4.72803 4.84631 +5476 4 9.7425 23.8424 39.9878 -14.1318 19.2209 8.44319 +5477 4 10.0514 25.1942 40.7028 -19.8613 -12.5192 -10.8686 +5478 6 14.4861 17.9115 14.2864 12.9549 -2.10551 -8.28408 +5479 4 13.7677 18.2592 13.7435 1.92348 1.2648 2.86628 +5480 4 15.2633 17.8567 13.6783 -18.4643 2.67645 15.1406 +5481 6 37.1346 38.6824 18.7128 7.24689 -5.58535 -9.53541 +5482 4 36.7159 39.5508 18.578 6.84706 -0.690413 -9.37485 +5483 4 37.7177 38.457 17.9456 -10.6272 10.0511 7.65618 +5484 6 11.4119 5.91281 21.4549 8.51563 -6.63227 17.2429 +5485 4 12.0074 5.45436 22.0841 -12.0343 5.82261 -11.8758 +5486 4 10.9825 5.24051 20.9122 -1.087 -4.70833 -2.40093 +5487 6 4.25375 30.708 16.2346 29.3973 -34.9884 0.269827 +5488 4 4.09384 31.4404 15.6668 -11.3131 25.7038 -10.6546 +5489 4 3.7498 30.7826 17.0293 -13.4231 7.50595 13.7704 +5490 6 17.6719 16.0027 27.067 -23.8279 -26.0778 -36.6424 +5491 4 17.4271 15.046 26.968 10.0078 22.1048 9.82572 +5492 4 17.2008 16.3672 26.2667 15.5193 1.39518 21.9495 +5493 6 36.5109 8.65039 40.4308 12.8187 7.82554 4.51092 +5494 4 36.6212 9.57953 40.6523 1.70353 1.63484 0.0365135 +5495 4 35.6422 8.38915 40.7323 -7.59123 -4.26386 -1.28756 +5496 6 13.6114 12.9582 3.02589 -9.62347 -2.84414 10.0553 +5497 4 13.2363 12.4097 3.76862 19.3807 16.1747 -17.4749 +5498 4 14.4444 13.4268 3.2396 -7.87441 -9.64772 8.81761 +5499 6 38.5595 20.1494 21.6232 12.4359 -2.6335 16.4863 +5500 4 39.2259 20.3435 20.9591 -1.48691 0.443177 -6.45697 +5501 4 37.7118 20.0829 21.2013 -17.1516 -4.14152 -12.2545 +5502 6 50.9933 10.2578 30.842 -13.0607 -20.693 1.71035 +5503 4 51.4592 11.0512 30.6346 13.219 20.5706 -0.472754 +5504 4 50.4501 10.1493 30.0523 -4.00654 -4.85851 -2.78428 +5505 6 16.2749 2.41767 41.3132 30.43 46.2693 -10.4997 +5506 4 15.891 1.63581 41.6436 -18.412 -43.9133 0.0464609 +5507 4 16.2795 2.47169 40.3396 -9.09423 -14.5759 6.47164 +5508 6 16.5834 4.98938 41.8776 -7.21709 18.0228 -35.1788 +5509 4 16.7462 5.00964 0.881122 10.2158 10.5242 44.5139 +5510 4 16.3516 4.0781 41.7536 -3.71457 -12.9135 -9.58407 +5511 6 38.2173 37.6461 20.9885 34.7311 9.53448 3.02785 +5512 4 38.1039 38.1836 20.1861 -3.89758 -6.06348 6.62032 +5513 4 39.1638 37.7895 21.271 -30.6928 -4.57838 -6.40603 +5514 6 27.3006 1.89931 15.7822 -29.9599 0.296682 7.03709 +5515 4 27.5073 1.31215 15.0574 1.93116 -3.76907 -9.96281 +5516 4 26.3073 1.90747 15.8082 23.9237 -0.0762349 1.33551 +5517 6 29.0265 12.4386 37.8107 0.525722 -10.271 3.33822 +5518 4 29.5022 13.2884 37.7591 0.646351 -6.15481 8.15455 +5519 4 29.2991 11.9227 38.6151 -0.523918 21.8031 -11.8471 +5520 6 46.0742 20.1649 18.9021 10.3528 7.89056 -10.7305 +5521 4 45.1842 20.5502 18.8696 3.90233 0.901411 -3.14496 +5522 4 46.6469 20.7119 18.3183 -8.66547 -7.99067 8.59505 +5523 6 2.04022 38.6829 18.5084 -2.98341 9.82285 -40.3455 +5524 4 2.90324 38.7749 18.9245 -0.612017 -3.29975 20.9344 +5525 4 1.3228 38.3823 19.0758 6.43327 -3.78011 20.6074 +5526 6 44.0503 24.9822 25.9794 4.67294 -4.59524 3.88497 +5527 4 44.3373 24.0607 26.0767 4.76241 4.2408 6.41339 +5528 4 43.5759 24.9717 25.1449 -4.92835 3.44315 -2.97359 +5529 6 5.98031 26.6293 4.53551 9.30387 5.64625 14.1271 +5530 4 6.57491 27.1353 5.14729 -11.3776 -17.0368 -12.135 +5531 4 6.21313 25.677 4.5841 -4.82905 19.4284 -2.02229 +5532 6 0.0924267 23.2133 10.9333 1.42961 0.53672 3.80218 +5533 4 0.717354 23.7388 10.4004 2.9288 -9.65077 10.1872 +5534 4 0.580921 22.6863 11.5989 -3.01683 9.30052 -9.37626 +5535 6 39.1222 20.6154 12.8741 28.3348 2.95161 0.461931 +5536 4 40.0468 20.8249 13.1753 -23.4009 -9.33487 -2.82098 +5537 4 38.9932 21.1408 12.0685 -0.0080483 -0.226832 2.68059 +5538 6 39.959 39.9495 18.871 8.01281 1.93571 -21.8826 +5539 4 39.6441 40.4313 18.0693 6.09748 -11.7745 18.4856 +5540 4 39.3412 40.1359 19.5607 -16.2687 5.42221 11.8382 +5541 6 49.288 23.0046 30.5128 21.2206 -9.75551 18.5897 +5542 4 49.5389 23.7528 30.0013 -1.98497 24.1116 -29.9204 +5543 4 49.9896 23.0569 31.1809 -5.40626 -11.587 6.30696 +5544 6 10.3545 2.34292 9.14765 -20.562 40.259 12.8074 +5545 4 10.1012 1.5797 8.68555 -3.02669 -36.876 -18.9145 +5546 4 9.58966 2.94108 8.9894 20.4134 -0.423974 9.05106 +5547 6 9.6115 40.9317 19.7379 12.0905 -27.6191 -4.08509 +5548 4 9.69139 40.7751 18.7589 3.32448 -0.840478 24.839 +5549 4 9.96472 40.0953 20.2033 -15.7711 32.9781 -27.126 +5550 6 29.2535 5.10379 17.4957 6.62295 15.7752 6.05206 +5551 4 28.9547 4.7998 16.6324 -1.76299 0.290572 -5.22762 +5552 4 29.5626 6.02275 17.3534 -3.29284 -14.1281 1.20249 +5553 6 27.0956 15.411 3.22262 8.43004 -47.4217 3.28637 +5554 4 27.2677 16.3043 3.38591 1.16524 52.1129 6.18754 +5555 4 27.741 14.9724 3.82188 -13.792 3.46242 -10.72 +5556 6 32.8341 39.3821 25.1177 -1.66938 -44.1854 21.376 +5557 4 32.6253 40.2767 24.9331 -7.27917 31.8978 1.68524 +5558 4 32.4689 39.1753 26.0219 6.68592 11.3878 -26.9617 +5559 6 34.9613 7.8883 31.2358 4.6626 36.0744 6.61898 +5560 4 34.1778 8.39814 31.5057 7.62156 3.23778 -2.6687 +5561 4 34.6431 7.01199 31.2355 -6.57887 -35.8668 -2.78431 +5562 6 6.13276 36.7597 26.1434 10.8988 16.6869 20.3463 +5563 4 6.63888 37.4372 26.6797 -12.2659 -21.448 -21.9021 +5564 4 6.61066 36.5785 25.3331 5.0666 0.722926 -2.43587 +5565 6 6.00975 25.8323 24.1014 -4.47961 0.932019 -2.36624 +5566 4 6.35352 25.3647 24.9068 -18.3984 14.8695 -13.0656 +5567 4 5.16189 26.3111 24.2876 18.65 -15.8322 7.58859 +5568 6 45.6302 24.3945 2.56021 19.8484 -5.54431 -0.0961329 +5569 4 46.4674 24.0527 2.19931 -2.34639 0.0383291 -2.49188 +5570 4 45.6784 24.1611 3.48508 -4.52597 -1.56916 11.2469 +5571 6 15.5147 11.7041 32.683 14.9804 20.126 19.7749 +5572 4 15.7333 12.537 33.1619 -4.31998 -20.325 -9.45866 +5573 4 14.9494 12.0119 31.9786 -9.0483 1.88099 -11.1618 +5574 6 46.4109 17.7015 37.4781 -27.0258 -32.7931 -28.9932 +5575 4 46.5427 17.8951 38.3867 3.19976 6.65122 29.0636 +5576 4 45.8763 16.8534 37.4192 15.4316 28.8096 -0.764517 +5577 6 39.7197 20.9143 18.534 -24.0731 20.2285 32.8184 +5578 4 40.3775 20.5463 17.9571 20.7324 -0.0260386 -6.5243 +5579 4 40.0771 21.5962 19.1648 -0.0511872 -19.8333 -22.8182 +5580 6 23.8035 28.041 36.6748 9.0016 14.1447 -6.24075 +5581 4 23.3139 27.2938 37.064 2.44252 16.2828 7.25552 +5582 4 23.789 28.845 37.2599 -7.88527 -27.7019 -2.97202 +5583 6 23.2344 0.634844 30.8976 -0.384503 -14.0448 -5.97485 +5584 4 23.3889 41.8653 31.5825 6.30765 2.44689 -9.38002 +5585 4 23.8441 0.49945 30.133 -8.72578 -2.57312 14.648 +5586 6 37.1436 6.89172 28.2858 -3.37167 6.44507 30.6351 +5587 4 36.8056 6.23733 28.9583 11.2574 17.9183 -21.3683 +5588 4 37.4325 7.68669 28.8192 -8.94015 -21.4647 -17.7418 +5589 6 3.23535 6.60909 12.3935 -1.87368 1.73448 8.36027 +5590 4 3.03832 6.9284 11.4867 8.20532 -9.84476 7.71099 +5591 4 3.52123 5.67427 12.3822 -6.77188 11.8795 -6.70084 +5592 6 12.6173 19.1518 31.1213 -5.69854 -18.2223 8.29425 +5593 4 12.5903 18.2248 31.5183 -0.203161 27.8336 -18.7857 +5594 4 12.2771 19.1425 30.2049 2.23067 -5.60852 14.6148 +5595 6 15.1884 38.3149 41.5578 -3.57026 -0.303434 0.776802 +5596 4 15.4085 38.7623 40.7331 -1.55695 3.41656 0.7558 +5597 4 16.0064 37.8692 41.7958 4.70682 -3.66196 2.37744 +5598 6 49.6308 33.3399 19.6427 -23.754 -26.2674 -4.71234 +5599 4 48.6425 33.4171 19.8493 35.7001 -9.4047 -10.4581 +5600 4 49.8006 32.395 19.3286 -9.63678 35.3831 11.1391 +5601 6 6.36026 2.78098 29.8944 3.74937 13.951 -9.77631 +5602 4 6.39713 3.75696 29.8119 -0.635871 -14.0149 2.80012 +5603 4 6.09114 2.63212 30.8044 -1.55083 -4.44243 9.60337 +5604 6 13.1715 31.7798 30.2783 -11.6407 3.9064 -21.9894 +5605 4 12.793 31.9725 29.3819 8.72012 -0.590438 18.6573 +5606 4 12.9685 30.8401 30.4245 2.82441 5.28785 4.26217 +5607 6 32.3245 32.246 24.8932 -0.334642 -17.4514 3.51608 +5608 4 32.5833 31.3985 24.4266 1.55373 29.7789 3.70352 +5609 4 32.7413 33.0821 24.5914 4.2936 -14.9539 -9.40787 +5610 6 41.9919 14.5701 37.4124 -31.8928 -38.2057 -11.1184 +5611 4 41.1925 13.9916 37.278 11.7187 28.3557 2.93562 +5612 4 42.6351 13.8531 37.4242 20.2579 6.94588 1.70752 +5613 6 11.8923 7.24234 27.6655 -13.1666 -25.4093 6.94854 +5614 4 11.7936 6.42612 28.2118 8.91213 18.8361 -2.40188 +5615 4 11.255 7.06027 26.9538 4.64331 9.73453 -0.841263 +5616 6 14.1973 37.538 6.88791 4.07782 -38.2298 -28.3639 +5617 4 14.4575 38.4426 6.80778 6.05638 30.4198 1.96843 +5618 4 14.5936 37.1092 6.07523 -12.6749 10.0326 27.426 +5619 6 14.2479 30.6948 36.0545 7.37408 36.4971 9.0133 +5620 4 14.3981 30.7629 35.1101 2.39159 -10.6067 -11.9788 +5621 4 14.1779 29.7876 36.2972 -1.09854 -35.7585 -0.14866 +5622 6 16.4334 33.6494 5.49228 -9.96541 -28.1856 -5.39099 +5623 4 16.7983 34.5397 5.45321 9.37649 -3.55324 -12.1003 +5624 4 16.7788 32.9912 4.81355 -0.655183 31.9156 12.6517 +5625 6 23.0317 17.1547 7.8473 13.6053 -0.132883 9.10362 +5626 4 22.1841 17.362 7.40272 9.91908 10.567 10.3381 +5627 4 23.4804 17.9296 8.30446 -24.7767 -19.3244 -18.4116 +5628 6 51.7425 20.8913 27.7088 32.6403 -5.30395 6.54704 +5629 4 51.4526 20.615 28.6066 9.31531 5.01366 -13.1678 +5630 4 52.7523 20.9899 27.7096 -40.0215 -4.95426 2.55021 +5631 6 2.19474 27.6072 28.8013 -23.9703 3.8216 12.4498 +5632 4 2.89306 28.2617 29.0045 8.22653 -14.998 -10.5048 +5633 4 2.42593 26.8662 28.2089 10.4722 10.3682 5.46115 +5634 6 17.2069 14.3387 7.70681 0.210359 -30.5014 22.2216 +5635 4 16.8342 14.1932 8.62484 13.2745 1.87397 -27.442 +5636 4 17.791 13.5503 7.49447 -17.8498 26.4292 5.4189 +5637 6 12.462 8.93964 14.7065 0.798528 8.71873 -6.67623 +5638 4 12.2438 7.98523 14.5568 11.6803 11.8078 17.0064 +5639 4 13.0577 9.12873 15.4809 -12.5262 -17.6243 -12.8578 +5640 6 42.4139 38.0579 9.76413 -20.5008 17.2265 16.0611 +5641 4 43.2035 37.8944 10.2554 20.3834 -6.45835 6.72371 +5642 4 41.8905 38.6035 10.3913 3.31942 -7.4886 -15.3201 +5643 6 51.8227 30.3513 28.272 -27.6927 -20.9124 31.2363 +5644 4 51.4089 31.1514 27.9711 0.163888 16.7369 -10.597 +5645 4 52.6546 30.2313 27.8441 24.1641 3.9866 -16.3823 +5646 6 0.181148 18.531 4.58976 -5.95747 22.8787 14.3331 +5647 4 0.30783 18.164 3.72574 1.94264 -10.8238 -19.8991 +5648 4 0.385506 17.861 5.23812 2.38695 -15.8688 4.81738 +5649 6 34.1492 0.61754 2.99129 -49.6439 4.42439 -16.0687 +5650 4 33.2398 0.938351 2.63038 43.5613 -10.8791 15.5023 +5651 4 34.8325 1.13587 2.566 3.67212 10.3309 -6.27046 +5652 6 49.171 17.2374 23.1529 12.6877 -22.0026 -17.2704 +5653 4 50.1002 17.5391 23.0823 -12.4494 -3.65532 2.68691 +5654 4 49.1558 16.3609 22.6932 2.16788 22.8154 9.36775 +5655 6 23.1488 6.5083 23.6124 -20.5997 37.6057 -45.0229 +5656 4 23.0491 7.12001 22.8007 18.1878 -21.95 27.0503 +5657 4 22.2316 6.45775 23.8939 -1.28085 -6.53623 13.7239 +5658 6 11.0806 24.0842 29.2705 -8.73998 -10.3514 -18.9502 +5659 4 11.2441 23.4599 28.5168 0.0150655 10.4905 16.9308 +5660 4 11.7296 23.9083 29.9561 7.87164 -2.5542 2.12029 +5661 6 36.5429 4.08242 21.672 0.786556 -8.94696 -15.3954 +5662 4 36.4501 4.49554 22.5359 -3.35109 8.47972 1.84417 +5663 4 36.356 4.76727 20.9996 1.47044 -5.20042 11.1851 +5664 6 31.3053 25.6355 24.591 -3.66138 3.71718 3.54675 +5665 4 31.1335 26.2845 25.3159 5.93159 -20.4343 -13.8963 +5666 4 32.0778 25.0682 24.8002 -7.66178 11.3294 7.22687 +5667 6 42.6065 23.0403 14.7613 -16.8309 4.03618 -45.3098 +5668 4 42.9655 23.4598 13.9577 -8.276 -4.36486 -1.00498 +5669 4 43.204 23.3098 15.4118 29.6291 10.3091 46.448 +5670 6 14.3159 11.6727 8.8813 -14.5655 -17.9373 -12.2817 +5671 4 13.3434 11.4421 8.85146 29.9821 6.96631 -2.22077 +5672 4 14.7728 10.9717 8.34565 -11.3371 15.3318 14.175 +5673 6 21.498 2.14139 3.39648 14.7702 -17.8734 -6.06988 +5674 4 22.405 2.21099 3.73647 -11.0312 3.8274 -0.37696 +5675 4 21.4855 1.24815 2.9799 -4.51333 14.3419 9.54204 +5676 6 22.4606 27.6741 39.0725 -9.38699 -8.57051 -12.0691 +5677 4 22.9487 28.2157 39.6788 9.87489 12.9386 7.45564 +5678 4 22.251 26.9021 39.5804 -3.7481 -10.0177 3.53978 +5679 6 37.2705 33.4961 30.0614 -4.9469 -17.1986 11.1636 +5680 4 36.5019 32.9393 30.3108 14.0133 8.69925 -1.52787 +5681 4 38.0636 33.0902 30.4641 -13.5236 2.40347 -6.71067 +5682 6 41.8394 20.8621 40.0097 -20.8091 -17.9415 -11.9484 +5683 4 40.8821 20.7467 40.2088 17.4772 5.45688 -4.89215 +5684 4 42.2425 21.2111 40.795 8.11745 4.61319 15.3924 +5685 6 10.0509 31.1054 22.2556 20.3961 -18.8014 17.2446 +5686 4 9.98499 30.8639 23.2007 -4.95143 3.66172 -13.3958 +5687 4 9.23459 31.4918 21.9926 -24.2979 8.76968 -3.95477 +5688 6 24.2243 35.3747 6.62617 -9.42531 -3.96828 -6.7527 +5689 4 23.2865 35.2144 6.56466 -9.91939 -6.68958 -24.4488 +5690 4 24.2401 35.6133 7.54088 22.4532 10.3619 17.5563 +5691 6 54.2249 13.3694 18.759 -24.737 -0.349871 -1.41807 +5692 4 53.5933 13.3703 18.006 15.3609 1.78219 9.05355 +5693 4 53.6566 13.499 19.5435 10.7967 -0.400371 -8.89572 +5694 6 12.4855 25.1013 17.4456 -6.57337 13.5018 5.68311 +5695 4 11.9686 25.7405 17.9864 9.67417 -13.0798 -6.23069 +5696 4 12.9177 24.4729 18.0482 -8.67745 6.31928 -4.55572 +5697 6 22.3956 33.969 18.8874 -5.8063 -1.6479 -7.81353 +5698 4 22.8035 34.4497 18.1359 -8.0332 -6.19684 5.18696 +5699 4 21.6693 33.408 18.5182 22.6878 13.045 2.20471 +5700 6 24.4435 12.9292 5.84415 8.74588 -19.8564 16.0901 +5701 4 24.6262 13.8512 5.99703 -0.326218 20.1414 -4.57271 +5702 4 23.8078 12.8376 5.13214 -2.90401 5.95194 -4.82348 +5703 6 13.3959 11.2335 28.6038 -6.74888 -5.61354 -5.54718 +5704 4 13.7674 10.4842 28.0847 -9.93712 8.82772 12.9583 +5705 4 12.6218 10.8864 29.0903 8.08376 -4.51111 -11.0518 +5706 6 20.9645 34.7015 21.139 -6.51648 1.45471 -0.425004 +5707 4 21.4543 35.0255 21.9119 2.52902 -3.67403 -7.94594 +5708 4 21.5071 34.7067 20.3201 -1.1119 -0.149268 16.7291 +5709 6 37.136 34.5081 26.161 6.62209 -8.97684 -22.2932 +5710 4 37.2438 34.333 25.2112 -5.73965 -6.14541 10.65 +5711 4 37.5173 35.375 26.2088 1.33918 12.2816 12.8311 +5712 6 49.3593 27.1123 23.4681 27.9614 -13.0657 2.71617 +5713 4 48.46 27.3383 23.3348 -38.0547 10.3981 -3.53627 +5714 4 49.5827 26.632 22.6632 1.14175 -6.15755 -6.01297 +5715 6 2.6463 41.7198 27.6524 7.3894 17.9878 -25.5957 +5716 4 2.49639 41.7504 26.6775 -8.79282 -10.4379 14.5056 +5717 4 3.38399 0.440368 27.7439 -10.0848 -7.80081 10.7778 +5718 6 28.2486 5.66281 0.851705 -28.2484 -11.3463 5.20358 +5719 4 29.1342 5.88017 0.643235 30.8656 11.4658 -5.99415 +5720 4 28.269 4.69693 0.891643 -4.88577 1.64465 1.4719 +5721 6 46.3319 19.9354 30.6504 10.2867 19.401 8.99033 +5722 4 46.9123 19.9353 29.8821 -3.84989 -4.07474 -6.11394 +5723 4 46.5975 20.7732 31.0971 -12.3274 -18.5124 -2.17733 +5724 6 3.63748 25.7835 21.5531 -13.3498 -8.40935 -29.3244 +5725 4 3.82697 24.8656 21.7578 10.5845 0.467441 11.0774 +5726 4 3.24958 25.6945 20.6565 5.98204 10.7305 11.6574 +5727 6 2.75525 19.0991 29.6309 -15.3907 3.66354 13.2976 +5728 4 3.52302 18.6052 29.9384 7.69741 -2.11378 -3.28897 +5729 4 2.98375 19.5594 28.8227 11.6258 3.58084 -5.99316 +5730 6 11.8998 35.7779 24.2574 -1.81403 7.91701 -5.71356 +5731 4 12.4147 34.9912 24.3376 10.7342 -20.9531 7.85436 +5732 4 12.5443 36.3811 23.8879 2.19538 16 -3.69366 +5733 6 52.3427 30.4062 14.294 22.5839 4.39347 1.37497 +5734 4 52.8745 31.0934 14.7488 -8.66891 -1.23278 -4.46489 +5735 4 51.4935 30.7804 14.0876 -13.5204 11.8147 1.32314 +5736 6 0.0822874 24.3672 32.1291 -8.34182 -9.5272 -6.40877 +5737 4 0.828194 24.8082 31.7001 -5.59692 5.0286 6.41936 +5738 4 -0.0482457 24.7479 33.0025 4.35174 8.79498 5.58774 +5739 6 31.4966 23.7292 38.8152 19.1094 38.0757 -4.99319 +5740 4 31.5999 23.5133 39.7508 -8.21927 -12.2318 -1.63758 +5741 4 30.9751 23.0699 38.3783 -13.0662 -23.7861 4.62116 +5742 6 52.1169 21.6052 3.50792 14.3711 -14.904 -13.5765 +5743 4 52.8807 21.6364 2.89306 -16.3122 -4.91238 6.22228 +5744 4 52.1257 22.4771 3.8768 -2.65107 18.1744 9.91254 +5745 6 31.7478 33.9414 11.5999 6.40399 -14.705 -7.35618 +5746 4 31.326 34.316 12.3745 -3.98661 3.76902 9.36008 +5747 4 32.1024 33.0666 11.8569 -5.74966 15.1553 -0.43871 +5748 6 7.04869 17.6722 16.6738 15.5169 9.78585 -46.6303 +5749 4 6.86408 17.1452 17.4554 -1.12856 -17.4359 1.80272 +5750 4 7.18951 17.0724 15.8577 -9.09698 16.5018 49.1326 +5751 6 51.856 41.8666 22.1892 3.84753 25.5265 -21.3427 +5752 4 52.3772 41.4924 22.8897 9.65371 -13.9556 16.5062 +5753 4 51.0512 41.3628 22.1522 -12.8828 -14.9996 6.2925 +5754 6 50.8708 9.92691 25.9357 -19.3562 -16.2947 3.52683 +5755 4 50.5833 10.1225 25.0455 -2.85771 2.39787 -5.58996 +5756 4 51.6551 10.4289 26.0882 17.2727 16.0662 4.10656 +5757 6 8.99927 39.8664 13.8488 -8.14038 -13.6283 -23.156 +5758 4 9.59929 39.3497 14.3885 6.06913 -3.61279 3.55219 +5759 4 8.79522 39.3067 13.0547 7.60199 16.2117 22.1745 +5760 6 40.7023 25.5302 0.148896 6.79038 -13.4508 8.01702 +5761 4 40.3789 25.4701 1.07476 14.4856 1.96217 -11.1718 +5762 4 41.6802 25.6099 0.149801 -17.1473 -2.90233 2.89792 +5763 6 46.6909 7.84537 22.8702 9.17253 9.27189 2.7581 +5764 4 46.223 7.4121 23.6122 6.69651 11.5962 -1.82232 +5765 4 47.0858 8.70418 23.1544 -10.5797 -14.2101 5.83025 +5766 6 21.013 12.9106 9.96683 -11.4772 33.9385 12.3935 +5767 4 21.4714 12.292 10.5062 17.1864 -22.5118 18.142 +5768 4 21.2487 12.7153 9.07972 8.38308 -10.8862 -30.7653 +5769 6 24.8549 0.515446 28.6008 5.68052 19.4063 -7.13145 +5770 4 24.6132 0.0822417 27.7678 -2.25298 -0.561161 -0.933523 +5771 4 24.9931 1.46483 28.3802 -3.69568 -16.6941 4.65055 +5772 6 9.93738 22.6806 8.27387 -17.0851 30.8612 6.83622 +5773 4 10.4469 21.9921 7.84938 5.97494 0.327216 -18.4105 +5774 4 9.65147 23.3826 7.61609 12.4321 -25.0338 8.46255 +5775 6 33.2759 9.25001 23.8237 4.47891 -44.2955 15.8461 +5776 4 33.2652 10.105 23.448 0.909732 36.8069 -18.0196 +5777 4 34.1325 8.84557 23.5962 -5.93924 6.51534 1.57833 +5778 6 47.795 20.3665 34.2866 5.36639 25.6433 -13.2606 +5779 4 47.2589 21.0165 33.753 7.81309 -27.8153 16.882 +5780 4 47.2984 19.5618 34.502 -10.2742 8.68957 -7.27829 +5781 6 7.49437 13.498 41.0843 -1.51987 -1.91843 -16.5508 +5782 4 7.4491 13.1887 40.147 4.71488 4.53153 18.247 +5783 4 8.31974 13.1617 41.4819 -4.68073 -1.19795 -7.02436 +5784 6 9.95832 23.5973 1.60681 5.21402 2.49741 5.68021 +5785 4 10.4402 24.1882 0.998507 -5.12041 -6.82862 1.89989 +5786 4 9.65493 22.8254 1.1174 1.14228 -2.219 -8.51506 +5787 6 27.3184 14.1623 11.3341 -13.0256 18.3326 19.191 +5788 4 27.0532 14.8043 10.6617 -0.288735 -3.87647 -1.15481 +5789 4 27.1082 14.6278 12.1878 10.7132 -11.7932 -20.1286 +5790 6 25.8363 31.783 17.8928 12.257 -31.4953 -8.75538 +5791 4 26.5912 31.2312 17.6268 -16.3657 -3.28218 2.7807 +5792 4 26.257 32.5845 18.0942 8.13437 40.9862 10.9181 +5793 6 28.5106 34.3419 0.227626 33.3873 17.7784 12.057 +5794 4 28.9852 33.8482 0.904042 3.3493 0.859906 2.37016 +5795 4 27.7339 33.8559 0.0766936 -35.6263 -19.3635 -8.63216 +5796 6 39.4752 27.6784 22.7097 42.3367 15.2059 -23.9811 +5797 4 38.5679 27.9307 22.8105 -22.3645 11.7157 0.32019 +5798 4 39.9498 28.4084 22.1978 -16.9125 -22.6846 16.1018 +5799 6 19.4034 35.5119 37.6428 33.5095 -11.1022 16.798 +5800 4 18.7953 34.9333 37.2031 -16.031 -7.23993 -11.3762 +5801 4 20.0399 34.8524 38.0282 -15.2165 20.9239 -9.15559 +5802 6 40.2577 30.223 10.7322 40.2352 -13.6393 -47.8395 +5803 4 40.0003 30.153 11.624 -20.3139 3.96126 40.955 +5804 4 39.7054 30.7997 10.2038 -14.6911 14.5022 3.62333 +5805 6 44.8252 28.467 36.0943 -27.9317 -39.6182 20.2271 +5806 4 44.1 27.9067 36.617 42.0807 42.9759 -26.5645 +5807 4 44.8315 29.4044 36.3472 -5.71594 -8.07431 0.279077 +5808 6 17.9328 13.9421 34.2756 -23.0398 37.6904 -16.8553 +5809 4 17.2847 14.658 34.0723 21.6532 -14.16 -3.36915 +5810 4 17.4769 13.4978 34.9742 -2.33669 -21.4636 20.9706 +5811 6 22.7722 11.8049 25.9053 18.1639 13.4769 -8.32772 +5812 4 22.5143 10.954 26.1764 -32.0329 -27.8082 11.3637 +5813 4 23.7113 11.6387 25.939 19.9678 17.8754 -6.33473 +5814 6 27.9844 31.9785 40.3628 4.4159 -7.73511 16.6787 +5815 4 28.3104 32.752 39.9101 2.36742 5.81951 -9.83175 +5816 4 27.6866 31.3262 39.7216 -3.89657 2.92736 -3.90823 +5817 6 29.7056 5.13899 29.6966 36.1554 -28.1732 -9.81385 +5818 4 29.3242 5.52633 30.4675 -11.5775 13.5815 21.5043 +5819 4 30.5867 4.74321 29.9895 -34.1051 15.4003 -14.984 +5820 6 3.10893 21.4798 2.76501 -7.99866 -19.5262 -7.43282 +5821 4 2.82658 22.3873 2.73831 -4.86294 14.1814 1.21532 +5822 4 2.47005 21.0041 2.20282 6.80672 4.92349 5.4824 +5823 6 13.6497 30.6638 39.7451 -45.1888 -1.5 -27.4221 +5824 4 14.5316 30.8766 39.996 26.4643 7.88404 -4.33129 +5825 4 13.4124 30.9677 38.8135 13.6057 -6.06521 34.9266 +5826 6 39.188 23.0895 28.2562 15.2318 22.185 -40.3341 +5827 4 39.2961 23.1894 27.2636 -4.5014 -1.37473 28.8386 +5828 4 38.6302 22.3345 28.3879 -14.2617 -17.3372 5.24228 +5829 6 16.9988 23.7489 0.769214 20.7079 -15.4466 5.05665 +5830 4 16.2107 23.4786 1.24898 -3.68938 2.33828 -2.20359 +5831 4 17.6949 23.1909 1.19915 -10.9726 17.7258 -9.6056 +5832 6 0.328251 33.6592 13.0294 5.05621 13.0457 -18.8804 +5833 4 55.0348 32.9975 13.677 0.78154 12.2617 9.8199 +5834 4 0.388277 34.5816 13.3997 -6.36603 -34.6234 2.68168 +5835 6 49.1005 40.6595 16.9496 -9.76098 4.73909 -13.8177 +5836 4 49.2151 40.9775 16.0207 -4.23419 -6.48803 14.4163 +5837 4 48.1506 40.7848 17.1408 8.79948 2.71791 -6.65809 +5838 6 52.1337 39.9918 15.1756 26.7545 10.0433 -2.50902 +5839 4 51.9708 40.0067 16.1202 -6.38877 -4.81519 5.40892 +5840 4 51.3465 39.7494 14.7166 -22.4824 -4.17003 -7.64187 +5841 6 29.052 37.1033 37.836 19.097 -0.968932 -4.5801 +5842 4 29.682 36.5364 38.3049 -8.87198 1.40853 -5.4338 +5843 4 28.3717 37.2982 38.474 -12.8547 4.6316 9.68073 +5844 6 4.87585 1.47991 27.5772 1.0193 4.57332 -1.4391 +5845 4 5.21258 1.06654 26.7686 1.92757 2.57678 7.5628 +5846 4 5.62617 1.67061 28.1638 -3.61661 -2.55781 -2.1886 +5847 6 43.5959 24.3463 30.211 -19.7182 -5.92862 14.3815 +5848 4 44.3514 23.9347 29.8066 13.2495 -10.0411 -7.84874 +5849 4 42.954 23.6392 30.3929 6.93549 5.0637 -4.64144 +5850 6 33.7524 3.52358 22.9355 4.65558 -3.45748 -24.1115 +5851 4 34.2253 2.7722 22.5212 -9.10678 14.6802 11.3369 +5852 4 33.6063 4.18077 22.2154 2.29559 -11.8514 17.7295 +5853 6 19.8909 13.4517 25.3922 5.25873 -5.74859 -7.9771 +5854 4 20.5096 14.0736 25.7535 5.66529 16.002 2.33546 +5855 4 19.9521 12.7313 26.0185 -3.34295 -15.2779 0.0169051 +5856 6 47.3737 23.1767 39.6212 -5.95621 11.0118 4.46955 +5857 4 47.7191 22.5265 39.0041 4.75348 -8.18234 -7.77672 +5858 4 47.7813 24.0201 39.3891 1.84918 -0.94156 0.213564 +5859 6 20.1771 18.6734 32.3906 -2.68035 -24.6067 18.319 +5860 4 19.7167 19.3347 31.8914 0.274713 15.8779 -14.5216 +5861 4 21.1289 18.7867 32.3383 1.39014 4.37005 -4.23212 +5862 6 0.462706 5.80795 25.6713 -7.84599 -7.21428 -45.242 +5863 4 0.323825 6.56383 25.0471 7.25451 -11.4554 20.6165 +5864 4 0.632949 6.14438 26.5418 1.37183 20.4375 17.7538 +5865 6 6.87393 19.55 31.9207 -32.7339 30.668 -22.5905 +5866 4 6.24577 19.9891 32.5577 15.6688 -11.8235 -17.9631 +5867 4 6.64633 19.9665 31.0139 13.7505 -20.7976 33.8805 +5868 6 6.72837 20.2799 38.5105 -3.64262 3.78431 -13.5507 +5869 4 5.92588 20.8248 38.5086 9.85336 -2.70512 -1.72466 +5870 4 6.83039 19.9897 39.4188 -3.49896 1.12624 1.5432 +5871 6 22.0356 25.927 12.2605 -11.8373 -4.76705 -8.63625 +5872 4 21.2326 25.5939 11.7351 40.6868 7.42656 16.975 +5873 4 22.8707 25.497 11.9923 -13.8486 -7.11072 -10.1952 +5874 6 39.3057 7.93299 2.64755 -0.118713 9.42534 0.0803503 +5875 4 39.6638 8.10481 3.53463 2.86319 -1.68774 -0.268253 +5876 4 39.5974 7.06378 2.35963 5.09861 -8.7519 2.38745 +5877 6 29.9647 22.0457 34.4057 2.14844 7.25734 -28.1517 +5878 4 30.9338 21.915 34.3365 -18.2911 3.03872 -0.832433 +5879 4 29.6238 22.2503 33.4865 4.56359 -4.84177 28.516 +5880 6 37.5951 16.2788 0.369586 8.64826 -19.3515 -0.400608 +5881 4 37.1939 15.3927 0.526929 9.97291 14.3398 -5.3998 +5882 4 38.4404 16.082 41.8172 -10.5319 -0.823814 4.55326 +5883 6 11.7218 13.8845 21.8896 14.7882 -39.2126 -46.5495 +5884 4 11.9305 13.3995 21.0267 -7.58848 27.5443 23.8472 +5885 4 11.7147 13.1405 22.4934 -2.11531 -1.20748 18.2217 +5886 6 33.352 10.9238 27.6262 4.19409 14.5082 -21.7958 +5887 4 32.741 11.5866 27.2704 3.79692 -6.80494 8.02232 +5888 4 34.0591 10.8732 26.9373 -11.2958 -2.76298 18.1193 +5889 6 30.9422 36.5217 10.1011 0.546516 -38.0529 -7.53065 +5890 4 31.037 36.4313 9.10316 -3.7795 -1.86296 33.6151 +5891 4 30.9555 35.5897 10.5034 1.2522 32.9448 -19.5962 +5892 6 45.5828 6.56917 25.2425 13.4794 -38.3135 -0.0969536 +5893 4 44.6735 6.51564 25.4913 -20.1668 12.9455 3.79285 +5894 4 45.8221 5.605 25.2656 2.31227 28.4662 -4.04899 +5895 6 9.53612 30.0233 12.041 13.8898 -20.9008 -19.4413 +5896 4 9.92894 30.5763 11.3437 -1.97905 0.820167 2.98642 +5897 4 9.13364 30.6129 12.6538 -15.721 17.9312 16.9413 +5898 6 53.0747 24.9738 1.38132 -1.86355 2.7084 19.7503 +5899 4 52.7154 24.2509 0.898374 -13.0694 -24.4059 -9.99565 +5900 4 53.2522 25.5795 0.686793 9.94881 23.634 -11.856 +5901 6 26.1984 24.7352 0.509304 -7.53082 -0.727442 -26.3589 +5902 4 25.609 24.783 41.6367 17.1237 -12.5609 6.929 +5903 4 25.7967 25.3842 1.06587 -1.32139 13.3231 25.2347 +5904 6 23.0109 2.41889 11.5345 -1.81733 -0.917938 -19.7561 +5905 4 22.156 2.16845 11.9124 1.98231 0.963836 1.10425 +5906 4 22.831 2.471 10.5696 1.38956 0.195961 11.1121 +5907 6 29.9165 12.8947 31.0013 41.0722 8.15666 -12.068 +5908 4 30.8272 12.8901 31.3843 -23.6061 -3.22469 3.62361 +5909 4 30.1671 13.0589 30.0659 -21.5099 -4.3955 11.2257 +5910 6 24.0423 16.1922 40.3682 -11.7161 -52.7791 -12.7633 +5911 4 23.7963 16.7427 41.0863 -4.03022 37.1909 22.8519 +5912 4 24.4513 16.6836 39.6566 3.29428 17.0417 2.56802 +5913 6 21.8759 29.9137 12.7377 16.7673 9.38207 5.68416 +5914 4 21.0615 29.603 12.3447 -12.732 2.54077 -5.12984 +5915 4 21.8572 30.8889 12.7388 -3.49843 -10.2696 0.0943897 +5916 6 45.2049 12.2865 6.6319 2.92472 30.2037 5.62675 +5917 4 45.4908 11.5347 6.14771 0.0808414 -27.1796 -10.0093 +5918 4 45.9331 12.9133 6.49804 -8.49251 3.31449 4.74769 +5919 6 7.58748 25.3948 38.035 37.4402 -5.69153 16.1754 +5920 4 8.20159 25.1941 37.2709 -20.479 6.14302 24.9331 +5921 4 8.13335 25.2556 38.8857 -20.6102 5.92378 -35.7711 +5922 6 46.1732 7.83303 16.6988 4.4841 14.5494 -17.535 +5923 4 46.5452 7.84101 15.8027 -9.24205 10.2202 -0.760543 +5924 4 46.6945 7.14485 17.0776 9.771 -19.5689 22.069 +5925 6 54.9675 12.85 7.71106 -14.5426 11.3809 9.40253 +5926 4 54.9732 13.8139 7.75484 8.59467 -0.566973 -8.90089 +5927 4 54.3786 12.658 8.45528 8.25441 -10.7611 -5.52346 +5928 6 26.93 39.6729 37.1759 35.4319 -17.0193 24.0328 +5929 4 27.7049 39.4447 36.6239 -16.3058 8.04164 -6.8945 +5930 4 27.2164 39.2553 38.0316 -23.1866 12.5553 -17.3208 +5931 6 27.0277 8.92497 38.0115 25.8258 -15.1538 -19.4143 +5932 4 26.3205 9.53863 38.1727 -14.2244 17.8778 -0.0983549 +5933 4 27.5327 9.26244 37.2322 -14.307 -2.33761 14.5508 +5934 6 8.04621 7.65921 29.9125 5.96085 -8.8046 12.0925 +5935 4 8.66182 7.92407 30.6202 -6.26406 -0.422529 -8.96361 +5936 4 7.80891 8.46925 29.4702 -0.676119 14.2 -7.80782 +5937 6 27.8751 27.8625 12.1001 -31.3933 22.4686 19.454 +5938 4 27.5095 28.719 12.4446 7.36494 -19.3603 -4.77408 +5939 4 28.6439 28.079 11.5991 25.5597 3.40516 -15.3306 +5940 6 23.5464 30.4867 38.1533 -1.61625 -6.62341 9.61758 +5941 4 24.0833 30.8354 38.8715 -5.37174 -4.61911 9.80189 +5942 4 23.9933 30.8636 37.4157 3.53805 3.96797 -22.0348 +5943 6 48.0805 24.2983 17.323 -13.282 16.609 -1.2587 +5944 4 47.4189 24.8263 17.8481 20.4082 -10.1323 -14.146 +5945 4 48.1392 24.7467 16.448 -1.93384 -6.90404 13.1726 +5946 6 38.5137 5.30503 40.3397 -7.95418 19.3032 15.6478 +5947 4 38.8605 4.51762 39.8919 14.9068 5.60332 0.485922 +5948 4 39.0782 6.12858 40.3573 -2.94219 -25.5867 -8.28862 +5949 6 31.2334 3.92786 33.7298 9.31662 9.08835 -13.8199 +5950 4 31.8178 4.24357 33.0198 -6.00608 1.6224 5.38661 +5951 4 31.5957 3.05883 33.9262 -1.57661 -10.2527 7.73336 +5952 6 41.2417 8.81323 38.1247 -0.484904 -12.0607 11.4744 +5953 4 40.9476 8.42023 38.9721 -0.376638 9.54125 -7.13918 +5954 4 41.2604 9.77162 38.2616 1.58028 -2.03482 4.89657 +5955 6 53.3602 29.1001 24.587 -11.0956 7.72569 2.80506 +5956 4 52.5731 28.5594 24.8544 13.5868 20.3826 -7.54714 +5957 4 53.0545 29.9696 24.221 1.09296 -21.6534 7.27768 +5958 6 54.9204 15.5334 40.7094 -9.73888 -15.8123 9.62316 +5959 4 54.8689 16.4143 40.4003 18.499 35.235 -15.9181 +5960 4 53.9936 15.418 40.9228 -4.36807 -19.1537 6.40504 +5961 6 46.4046 17.0769 31.8825 -4.88415 8.61979 -0.317809 +5962 4 46.5643 17.9902 31.5503 -4.54791 -14.0743 0.407713 +5963 4 45.6863 16.6828 31.3336 12.87 12.2001 8.08584 +5964 6 36.9136 25.0502 23.0508 4.56287 5.14957 -21.3849 +5965 4 37.1181 25.0639 23.9643 8.53293 7.7605 31.6671 +5966 4 36.2092 24.4176 22.9617 -10.0712 -5.98832 -5.36051 +5967 6 11.3786 4.43396 15.9309 9.37238 17.2608 -3.05203 +5968 4 11.3458 3.5794 15.4688 2.43716 9.1998 0.97888 +5969 4 11.7026 5.12247 15.2999 -5.70859 -16.4138 5.77914 +5970 6 12.7896 7.06818 19.4525 -2.66824 36.6483 10.7184 +5971 4 12.9865 6.29411 18.9417 0.495259 -24.323 -4.17525 +5972 4 12.2519 6.828 20.2299 7.04203 -8.59773 -13.3487 +5973 6 12.0617 33.6499 17.5439 8.15138 -13.8576 -23.5514 +5974 4 11.882 34.0654 18.3682 -11.1792 16.7137 24.4072 +5975 4 12.5902 32.8825 17.8108 -1.08307 -0.300652 -3.52071 +5976 6 10.2421 4.75805 2.56564 19.3085 -11.8452 1.86691 +5977 4 9.45693 4.42703 2.99801 -10.4664 -1.42643 2.59081 +5978 4 10.9264 4.04527 2.68225 -6.18235 16.1727 -3.70264 +5979 6 4.57251 36.8735 12.1563 3.74049 -23.6741 -21.1206 +5980 4 4.47996 37.7154 12.5491 -11.9533 34.2042 20.255 +5981 4 5.43811 36.9355 11.7449 0.921031 -10.3689 -0.351167 +5982 6 30.7412 35.3317 25.8213 -33.1423 -23.543 6.44877 +5983 4 31.2776 35.279 26.6136 10.5944 3.70967 -1.00248 +5984 4 29.9668 34.7615 26.0677 13.1622 11.7399 -12.7178 +5985 6 20.1808 7.16217 1.863 30.1084 16.4868 -11.867 +5986 4 20.9002 6.54767 2.16414 -16.0511 17.5979 -8.58506 +5987 4 20.6676 7.94845 1.45686 -14.4541 -29.1822 13.3394 +5988 6 21.7608 6.89709 28.9964 -11.5861 -1.80466 -8.03013 +5989 4 22.036 7.16072 29.8728 6.26891 1.69864 13.9065 +5990 4 22.5393 6.5849 28.5353 8.83449 0.101288 -1.59126 +5991 6 6.87368 37.1369 6.9386 0.0966708 26.3677 27.0276 +5992 4 7.29364 38.0249 6.81033 -7.58004 -19.2864 -7.26696 +5993 4 6.61926 37.1727 7.88431 1.83825 -7.02501 -19.6681 +5994 6 37.1919 18.383 16.2937 29.0289 34.5069 -53.2335 +5995 4 36.6258 18.6038 17.011 -19.1901 14.6481 22.2869 +5996 4 37.3395 19.2625 15.7718 -11.4936 -34.1346 27.3139 +5997 6 52.3871 25.4845 31.3088 43.0013 26.9533 24.6388 +5998 4 52.3889 26.4071 31.692 -12.9868 -26.5619 -15.078 +5999 4 53.3562 25.2868 31.368 -25.5563 -9.18093 -7.26498 +6000 6 3.9438 39.8542 16.3866 5.1752 -27.5036 1.27902 +6001 4 3.12325 39.6837 16.8533 -2.95342 6.97088 0.658243 +6002 4 4.2268 38.9387 16.1321 1.7457 31.291 -0.663648 +6003 6 26.0576 14.6358 18.3044 5.96149 26.4073 -5.45028 +6004 4 27.0205 14.6227 18.4365 -6.17521 2.0803 0.6884 +6005 4 25.8163 15.5963 18.2277 1.60591 -22.5499 1.70317 +6006 6 22.193 39.6312 23.63 -9.05536 -28.9999 9.83005 +6007 4 22.6639 40.3889 23.3083 10.2118 22.7493 1.36107 +6008 4 21.7625 39.8434 24.4837 8.53947 8.47814 -10.8223 +6009 6 5.99591 12.8758 22.3742 5.3436 -0.661706 -0.190442 +6010 4 6.14325 13.1833 21.4713 -0.679137 1.38292 -0.893953 +6011 4 6.87425 12.6139 22.6767 3.78948 -2.07704 1.05968 +6012 6 48.9338 28.1628 34.7078 -35.8712 26.2385 4.15493 +6013 4 48.201 27.5556 34.4701 19.6025 -0.265843 1.21851 +6014 4 49.8217 27.8183 34.7001 12.2446 -20.4038 -3.75147 +6015 6 7.76997 22.4407 33.2353 -5.03116 -11.9457 7.57841 +6016 4 8.01899 22.0009 34.0594 5.33952 7.11928 -2.86974 +6017 4 7.10669 21.8538 32.8613 -1.17853 4.26119 -2.40878 +6018 6 41.0955 39.6222 11.7091 10.6381 -27.5326 3.52715 +6019 4 40.5189 40.2602 11.288 0.0449404 21.7474 -0.525631 +6020 4 41.8612 39.9918 12.1934 -14.1016 15.1893 -9.59654 +6021 6 26.8828 37.915 39.359 -2.28209 0.567193 11.8658 +6022 4 27.0774 38.1179 40.3058 -8.7685 -4.90824 -13.677 +6023 4 25.9807 37.5277 39.3071 12.6176 5.79057 5.20946 +6024 6 16.8333 41.5427 16.7885 -17.5694 -7.84814 -1.75502 +6025 4 17.5277 0.148354 16.3589 5.69783 -2.62712 11.3029 +6026 4 16.9979 41.3393 17.726 8.37907 5.88226 -10.2657 +6027 6 19.018 8.99657 17.6669 -0.857073 -13.2853 32.8939 +6028 4 18.786 9.90902 17.9004 1.19423 -0.949069 -3.8378 +6029 4 19.1413 8.47286 18.5173 -2.13518 15.132 -32.6231 +6030 6 31.1034 24.3848 20.0884 -4.53251 11.7336 -2.81937 +6031 4 30.5766 24.6463 20.8643 6.13742 -4.20791 -6.36966 +6032 4 31.7352 25.0989 19.9557 0.422515 0.146513 0.562515 +6033 6 24.595 6.30881 27.6069 -9.90555 -11.0232 -14.6341 +6034 4 24.6965 6.6392 26.7007 0.89989 8.76246 8.56835 +6035 4 24.5083 5.35606 27.4824 0.344086 -1.65377 9.53776 +6036 6 11.6335 5.32908 8.21523 29.3959 14.5761 -12.3078 +6037 4 10.744 5.12885 8.4339 -32.4949 -9.42488 11.9016 +6038 4 11.5648 6.10082 7.62627 0.276207 -9.77668 5.48929 +6039 6 16.478 34.2375 17.2464 48.0037 -1.61779 7.84119 +6040 4 15.7306 34.6529 16.8034 2.48832 11.605 -8.49411 +6041 4 17.405 34.6677 17.061 -56.7063 -17.2336 2.19282 +6042 6 40.7477 40.4696 8.51561 8.11488 -8.65224 -15.2287 +6043 4 40.0224 40.6832 9.09702 -8.50867 2.70994 6.70857 +6044 4 40.4514 39.6579 8.0617 2.3787 8.8385 5.97324 +6045 6 42.7444 5.87231 14.2984 24.2128 7.61876 -1.56509 +6046 4 42.0757 5.96647 14.9632 -14.4615 -1.80987 8.42029 +6047 4 42.482 5.17586 13.6922 -11.2697 -3.69634 -0.0191913 +6048 6 14.3614 21.0573 6.06698 -40.3301 2.02826 20.3099 +6049 4 14.5082 21.6099 6.85229 1.25225 -5.13952 -5.68983 +6050 4 15.1941 20.9025 5.67555 35.2665 -1.55979 -15.977 +6051 6 16.3015 37.7733 18.121 -25.7671 9.10936 -15.4408 +6052 4 15.381 38.1761 18.2458 41.2545 -15.1679 7.93486 +6053 4 16.7788 37.6858 18.9587 -11.1023 5.71932 1.62274 +6054 6 40.7984 27.7161 27.1129 -11.0179 0.499807 -0.336913 +6055 4 41.4742 27.2927 27.66 5.56711 1.79851 -1.75817 +6056 4 41.2133 28.334 26.4954 6.67104 -1.0644 4.19578 +6057 6 44.9561 25.991 14.0487 25.7727 -16.7938 -19.0088 +6058 4 45.3739 25.1637 13.7108 -16.5098 12.8855 15.8726 +6059 4 45.5476 26.6442 13.6478 -7.0093 2.51014 3.36733 +6060 6 2.61494 33.9473 21.2474 -9.6198 2.06317 -4.83635 +6061 4 2.13704 34.7904 21.3802 4.44423 -7.12162 -0.559399 +6062 4 2.10703 33.4352 20.5879 2.52794 8.8644 7.26413 +6063 6 5.77575 4.45209 12.8318 1.03208 18.7287 8.08797 +6064 4 5.35339 3.69685 13.2518 -3.06112 -10.1665 -2.69945 +6065 4 5.8052 5.15326 13.507 0.887863 -7.02627 -5.52828 +6066 6 16.8649 5.92112 7.40874 19.9951 -5.29142 4.66315 +6067 4 16.4994 5.07825 7.12483 -4.58221 -9.71617 -5.56506 +6068 4 16.109 6.48147 7.52662 -16.4719 8.95214 3.19539 +6069 6 17.8298 38.4233 36.8534 9.258 40.3096 -0.310058 +6070 4 17.7926 39.4131 36.8935 -6.04129 -19.7424 1.84578 +6071 4 18.5177 38.2893 36.201 1.93535 -10.8086 -1.92368 +6072 6 43.3019 20.5959 5.44166 -6.9278 5.85438 -3.52603 +6073 4 43.1055 21.501 5.07158 -2.97833 -26.833 8.04502 +6074 4 42.4661 20.0651 5.41852 11.3272 16.2867 -2.99003 +6075 6 21.5372 23.2991 30.4448 -14.935 11.2275 -26.3705 +6076 4 20.9947 23.0537 31.1809 -7.12546 -6.28648 20.8256 +6077 4 20.8648 23.582 29.7655 22.6032 -4.28693 10.3415 +6078 6 0.251317 28.0486 36.1651 -22.0243 21.0356 -19.5016 +6079 4 1.02049 27.7114 36.6113 18.9729 -1.47718 6.47801 +6080 4 0.506474 28.8456 35.6445 2.58205 -12.8812 9.00708 +6081 6 3.04678 17.0589 11.5707 1.23946 -7.00965 -18.5436 +6082 4 3.14519 17.2619 12.4977 -1.89892 8.1653 13.6088 +6083 4 2.54959 17.7766 11.1613 1.73961 1.36316 5.23635 +6084 6 24.1645 37.0333 23.9496 -13.0802 10.7124 17.6799 +6085 4 23.6099 37.8384 23.8849 6.1763 -9.33563 -1.28122 +6086 4 24.4663 37.0147 24.8893 -3.58635 -1.49958 -18.3056 +6087 6 3.94341 20.5209 27.4789 6.12038 36.4957 26.1587 +6088 4 3.64002 20.0757 26.7101 -13.0247 -10.3927 -30.3524 +6089 4 3.8213 21.4921 27.3096 0.6263 -21.942 -1.90407 +6090 6 54.8381 2.78983 29.6272 25.3782 12.002 29.7256 +6091 4 54.8259 2.49183 30.5832 -3.08894 8.50949 -25.0172 +6092 4 0.681738 3.33643 29.5869 -23.0163 -14.7319 0.890579 +6093 6 27.1738 8.43221 31.7209 4.37325 44.8318 10.1666 +6094 4 26.7765 8.21235 30.8513 3.34031 12.9925 0.247925 +6095 4 27.4394 9.43578 31.8184 -18.7706 -51.1708 -12.8964 +6096 6 30.9422 1.62815 30.3909 7.68258 9.19266 14.5116 +6097 4 30.6848 0.902997 29.8247 -17.6873 -14.6962 -9.63211 +6098 4 30.1385 1.96768 30.8202 -2.70664 -9.08975 -4.26502 +6099 6 26.4126 36.4396 36.8407 14.7094 2.78685 2.16538 +6100 4 26.1754 35.936 36.0621 -1.37556 -1.6634 -9.1832 +6101 4 27.3614 36.6667 36.7609 -11.9856 -2.56278 0.470716 +6102 6 51.3051 10.055 21.7064 16.9271 -12.7171 -0.47742 +6103 4 50.71 9.38094 22.0984 13.3581 11.7028 -6.50503 +6104 4 52.1297 9.58932 21.3894 -28.6693 12.5934 9.83408 +6105 6 52.4269 12.3712 23.2743 -6.4707 23.0639 13.1163 +6106 4 51.7645 13.1043 23.2119 13.6159 -11.3613 1.42096 +6107 4 52.024 11.6223 22.842 -6.69009 -13.0182 -9.76131 +6108 6 10.0084 38.37 20.6075 21.9453 -2.41338 -4.30271 +6109 4 9.45069 38.2813 21.3825 -6.19229 -0.201962 6.85596 +6110 4 10.9137 38.1225 20.8794 -8.5598 0.614521 -3.9406 +6111 6 22.7031 33.2664 0.640708 10.9794 6.62646 4.85135 +6112 4 23.6679 33.2996 0.582378 1.56947 7.5672 2.73741 +6113 4 22.5144 32.4288 0.230474 -14.5468 -15.5809 -6.04383 +6114 6 14.0917 40.8812 25.4864 9.18744 8.89463 -14.7226 +6115 4 14.196 40.6884 26.4283 -5.63746 -5.20078 0.271339 +6116 4 13.2439 40.5125 25.1796 5.27736 1.6069 9.18822 +6117 6 42.7681 15.0783 14.9763 7.15748 5.71054 -2.59845 +6118 4 43.0785 15.7158 14.2901 -5.10451 -16.9901 16.8665 +6119 4 41.8327 15.2592 15.1092 -5.54173 -0.124331 1.80857 +6120 6 30.2406 7.22111 8.53832 -0.545825 26.9265 -4.64375 +6121 4 30.1758 8.19473 8.52708 -1.1145 -9.52086 -16.9196 +6122 4 30.4024 7.07989 9.45321 5.06633 -17.0605 24.2519 +6123 6 3.37759 19.8423 41.3077 23.4194 0.89426 -0.123069 +6124 4 3.19865 19.3681 40.4829 0.842743 3.23829 1.04749 +6125 4 4.34953 20.0012 41.2688 -20.407 -4.57585 2.1738 +6126 6 8.87423 25.1354 17.2017 -10.0567 -4.23249 -18.7298 +6127 4 8.96932 24.947 16.2256 5.94886 2.92938 28.6011 +6128 4 9.65182 24.8278 17.6915 0.0257745 -5.63434 -9.64419 +6129 6 9.32494 14.9555 22.0283 -12.5325 4.5599 7.62514 +6130 4 9.01993 14.8718 22.9489 -0.27625 1.365 -7.1979 +6131 4 10.1958 14.5523 22.0148 2.38734 -2.44115 -2.54227 +6132 6 2.03086 4.7751 20.8592 -0.302533 -25.5342 -8.8148 +6133 4 2.76807 5.37577 20.9697 7.90436 11.3601 5.00545 +6134 4 1.2576 5.15949 21.2703 -7.54078 11.376 6.7073 +6135 6 18.2964 7.06718 3.86051 -0.633466 1.54328 39.8902 +6136 4 18.916 7.22135 3.16498 20.2468 5.35447 -22.1173 +6137 4 18.8081 6.54637 4.52758 -12.8964 10.087 -8.61721 +6138 6 17.0178 19.1734 19.8425 8.05121 8.342 4.19715 +6139 4 17.786 18.9037 19.3194 -9.06534 -4.96345 -2.22737 +6140 4 16.269 18.585 19.6427 11.1227 0.819232 -3.01639 +6141 6 4.30363 6.55267 21.3463 7.67654 -0.43578 -3.38259 +6142 4 4.33009 7.06923 20.5107 4.36212 -5.74714 10.2686 +6143 4 5.22777 6.26626 21.5669 -20.6993 9.2157 -12.5452 +6144 6 20.7848 36.9284 35.662 4.03453 1.95325 3.7669 +6145 4 20.2254 37.0836 34.8976 -2.25577 1.87165 -3.27163 +6146 4 20.2383 36.4327 36.2875 0.848364 -0.11832 4.44878 +6147 6 4.7306 15.0205 31.2333 -1.91968 -20.8619 8.65585 +6148 4 4.4229 14.7734 32.1398 6.18773 10.2906 -17.1472 +6149 4 4.73385 15.973 31.1263 -2.35963 8.87481 4.31723 +6150 6 2.35358 1.22877 17.5767 10.9459 -8.92502 -6.22121 +6151 4 3.05741 1.28614 16.8672 -19.772 5.07478 19.7417 +6152 4 1.94409 2.09607 17.7592 7.86728 -5.07336 -5.26938 +6153 6 34.6221 31.5613 19.8029 0.0167231 -1.91103 -0.857839 +6154 4 35.0026 31.8698 18.9629 1.12657 -3.13716 4.28436 +6155 4 34.4223 32.3623 20.3103 -0.485441 0.265221 -3.01806 +6156 6 24.1912 21.6103 13.5173 31.6251 8.72647 13.7111 +6157 4 25.0921 21.8731 13.8418 -25.6554 -7.43575 -12.369 +6158 4 23.5893 22.1875 13.984 -2.65104 7.77201 2.87587 +6159 6 37.2187 41.0834 5.69361 1.76676 -13.0415 -0.936073 +6160 4 37.8761 41.7354 5.91144 16.7665 3.57334 0.125879 +6161 4 36.4089 41.5349 5.88363 -19.4064 5.82624 -1.33385 +6162 6 8.4323 8.00063 20.2395 28.2224 -17.334 -6.20124 +6163 4 9.29892 8.115 20.6547 2.73811 -3.60152 -0.447724 +6164 4 7.94828 8.69862 20.6224 -29.3938 29.4062 12.6481 +6165 6 14.9357 18.8843 36.7618 11.8158 33.7978 0.271425 +6166 4 14.1259 19.2123 36.362 -3.40669 -6.42507 -0.135577 +6167 4 15.5651 19.6361 36.6422 -7.52364 -17.7077 5.06346 +6168 6 43.9725 40.6444 18.6569 4.16672 -2.33153 16.0012 +6169 4 43.9166 40.834 17.7203 0.682613 4.51617 -13.4207 +6170 4 44.9212 40.6761 18.9032 -12.0211 -3.47257 -3.21486 +6171 6 33.7852 32.2494 37.3449 -11.8504 2.76306 -14.1758 +6172 4 34.0177 32.2775 36.4055 -1.41242 -0.232407 11.1732 +6173 4 34.3686 31.6236 37.7745 10.7747 -2.06792 3.13276 +6174 6 5.09749 29.2901 24.0356 16.7213 -6.5526 19.7529 +6175 4 5.77222 29.487 24.7328 -11.5239 -2.29901 -14.2657 +6176 4 4.7684 30.1321 23.7215 -1.73734 11.0072 -2.10513 +6177 6 33.6153 36.4198 10.9805 1.47517 3.52666 5.33615 +6178 4 32.7579 36.4403 10.5596 -3.06779 3.10292 -7.60642 +6179 4 33.384 36.4828 11.91 5.71512 -0.747971 7.16991 +6180 6 28.3006 33.5952 13.1115 6.62888 -15.4249 13.7129 +6181 4 27.948 33.7778 12.2398 -4.56551 -8.24283 -4.77521 +6182 4 28.1705 32.6462 13.2914 -0.364449 12.3294 -7.26248 +6183 6 6.16378 19.058 24.2919 3.99573 -9.29146 -27.7059 +6184 4 6.01812 19.825 24.8144 -3.49512 27.1397 16.8881 +6185 4 6.29927 18.3335 24.8859 3.7649 -20.2974 16.0908 +6186 6 28.4267 19.9356 1.8581 6.30761 1.98196 1.30153 +6187 4 28.5945 19.3745 1.10227 -2.74725 -9.675 -9.29711 +6188 4 29.2893 20.1184 2.23075 1.76934 5.71608 2.57016 +6189 6 42.0557 23.969 9.55925 -0.174378 -1.97525 4.49576 +6190 4 42.3037 23.8044 10.4694 5.92504 9.79373 11.5418 +6191 4 41.7282 23.1152 9.29053 -8.19873 -12.6145 -11.7634 +6192 6 43.5187 7.30226 27.4319 7.08124 -12.3985 0.368771 +6193 4 42.7424 7.14751 27.9838 -5.23639 1.01312 3.8871 +6194 4 43.2552 7.97753 26.8025 -4.71413 8.37143 -8.21745 +6195 6 20.4824 33.0041 9.27291 -32.573 -27.3267 34.6611 +6196 4 19.7824 32.5876 9.93875 35.2414 32.5831 -36.6535 +6197 4 20.3431 33.9616 9.1663 -10.2228 -2.75758 9.24016 +6198 6 38.0326 35.2526 15.9362 -7.94884 -19.6622 -5.99631 +6199 4 37.3459 34.9971 15.2894 4.63074 2.95951 5.93375 +6200 4 37.9463 34.6017 16.6504 2.45283 5.99568 -2.76115 +6201 6 47.5301 20.8853 3.96175 -5.34824 -5.66637 20.3565 +6202 4 47.9759 21.3648 3.2498 -4.9297 7.97101 8.48596 +6203 4 47.5029 21.3928 4.81786 6.75175 -1.3172 -26.6206 +6204 6 10.9933 31.6966 41.4271 11.47 5.02521 -0.853614 +6205 4 11.6392 31.7665 40.7132 0.112137 -5.28149 3.10577 +6206 4 10.1353 31.6993 40.998 -8.62143 -0.203152 -1.66696 +6207 6 43.2403 12.6562 2.57215 9.62694 -8.68348 -18.5989 +6208 4 42.9077 12.993 3.39384 -2.38679 2.43178 19.528 +6209 4 44.033 12.1261 2.78242 -8.9232 8.2725 3.71991 +6210 6 49.4204 25.4105 21.1683 5.59269 -12.2048 -2.72561 +6211 4 50.0196 25.2987 20.4097 -7.64964 4.29225 2.01473 +6212 4 48.8877 24.5919 21.195 1.69169 7.44836 1.02425 +6213 6 1.95674 34.1403 26.4747 8.8762 -24.2704 6.47661 +6214 4 2.77674 33.6103 26.5537 -12.4269 14.6955 -4.62849 +6215 4 1.26657 33.4613 26.3994 -1.21739 9.31774 -1.03397 +6216 6 17.1306 20.8229 36.6851 -31.9931 14.1441 13.8122 +6217 4 16.9533 21.7471 36.9985 5.62896 -19.6931 -5.93312 +6218 4 18.0634 20.696 36.5868 23.783 -2.64609 -3.70934 +6219 6 36.6048 10.9866 3.71548 -5.44552 8.31799 24.2539 +6220 4 35.7423 11.3886 3.87785 -5.6936 5.55042 -13.8219 +6221 4 36.8135 10.7077 4.61447 10.9535 -7.59336 -0.361553 +6222 6 14.2169 20.6838 21.9439 11.6961 23.12 -6.3106 +6223 4 13.8085 20.2376 21.1912 1.98746 8.13024 -7.83415 +6224 4 14.8103 21.4259 21.6461 -14.674 -27.097 -1.82439 +6225 6 33.9151 12.2544 9.54899 39.8857 -26.0408 -21.0892 +6226 4 34.3088 11.5163 10.0208 11.0461 -3.70138 -11.6499 +6227 4 33.2997 12.4814 10.1903 -47.9458 31.9244 32.2008 +6228 6 21.8056 41.4836 2.15686 0.64336 -1.87746 -8.80618 +6229 4 22.0354 41.6672 1.22189 -5.57638 1.91412 12.8342 +6230 4 22.5122 40.9391 2.50884 5.16687 -0.375256 0.644554 +6231 6 20.9282 10.4547 14.1996 25.019 -0.0729632 25.5582 +6232 4 21.5922 10.842 14.8375 -21.0894 -6.80718 -21.5316 +6233 4 20.826 9.54084 14.5456 -0.887825 12.9084 -9.51249 +6234 6 6.24616 4.45231 24.6293 -10.9468 0.993291 2.39826 +6235 4 6.83688 4.17894 23.9311 12.242 -0.137787 -14.9911 +6236 4 5.68087 3.68408 24.7586 -3.59028 -1.51582 -1.5433 +6237 6 50.784 14.5954 23.4824 21.8736 9.84292 5.60122 +6238 4 51.2681 15.1205 24.1582 -9.03857 -7.6656 -10.4761 +6239 4 49.9341 14.3608 23.8519 -7.60536 -4.54693 6.65168 +6240 6 52.7678 13.9144 9.68214 -3.90955 36.1598 -0.40974 +6241 4 52.8738 13.0144 9.92216 4.47335 -34.5538 7.53363 +6242 4 51.8729 14.0092 9.35938 -14.036 0.105332 -6.17221 +6243 6 9.05048 2.05234 29.9152 -29.3842 -12.1538 -14.6176 +6244 4 9.42756 2.83336 30.2687 13.3628 24.1087 13.7335 +6245 4 8.09173 2.26823 29.8032 18.9866 -6.39081 0.174186 +6246 6 7.13499 29.9757 26.2377 7.52656 -33.046 2.78556 +6247 4 6.52748 30.39 26.8607 -0.20976 -1.88395 4.87081 +6248 4 7.49713 29.1538 26.6869 -11.4544 24.9502 -11.4644 +6249 6 49.1541 41.742 14.3355 11.4439 21.5488 -10.6063 +6250 4 49.5333 41.2573 13.5835 -2.72613 -5.13007 3.47372 +6251 4 49.526 0.750494 14.2401 -8.50163 -23.9907 2.80869 +6252 6 5.64545 3.82333 19.1929 -5.43924 -10.1162 19.2647 +6253 4 5.12472 3.39384 19.906 6.51959 7.46947 -11.8792 +6254 4 5.07872 3.8651 18.4273 -3.31865 2.78603 -7.74707 +6255 6 9.32747 35.8381 24.9081 -3.67476 7.0144 6.61099 +6256 4 10.2167 35.7622 24.5243 -1.5306 1.39279 3.84516 +6257 4 9.42305 36.4736 25.6393 1.10498 -0.920313 -3.33942 +6258 6 53.0258 29.7567 11.5493 -1.29773 -2.97991 8.71205 +6259 4 53.4398 30.4104 10.9769 2.6525 4.63524 -3.89524 +6260 4 52.8324 30.2122 12.386 1.27544 -1.91261 -4.55584 +6261 6 22.6082 9.97702 5.69106 1.45951 -2.04334 43.7981 +6262 4 23.4598 10.2484 6.09617 -7.85329 -3.83944 -13.5574 +6263 4 22.5497 10.2693 4.79236 2.60512 5.60546 -21.7219 +6264 6 39.5532 19.6216 2.68726 -3.50035 -14.5445 -22.3968 +6265 4 38.6563 19.3067 2.54039 -1.65167 0.121811 17.9309 +6266 4 39.9003 19.405 1.80953 18.3116 7.78412 6.67062 +6267 6 45.082 35.5833 7.81025 20.3465 -2.3491 -25.2688 +6268 4 45.1219 36.3229 8.40611 -5.73741 11.9797 15.8104 +6269 4 44.452 34.9332 8.12016 -12.4923 -3.86067 9.83054 +6270 6 29.7976 14.244 9.96067 -5.32248 -4.64296 1.12628 +6271 4 30.0443 14.0971 9.02808 -4.18819 -1.64606 2.67632 +6272 4 28.8444 14.0269 10.0606 18.5465 4.64021 -4.02524 +6273 6 29.2523 30.155 21.8932 -5.77992 6.30922 3.94049 +6274 4 29.1431 30.8143 21.21 -7.42967 10.4849 -3.0507 +6275 4 30.0153 29.6632 21.6201 11.6336 -14.2167 -2.13367 +6276 6 11.1107 18.8213 6.56056 -14.6836 -1.88929 0.635516 +6277 4 11.166 19.7501 6.27543 7.98891 -2.6539 -0.194038 +6278 4 11.9915 18.4225 6.59495 6.41359 9.14832 -2.51569 +6279 6 13.4142 39.1371 13.4638 17.7807 -10.3765 -23.6259 +6280 4 13.7831 39.7975 14.0449 5.16656 9.87024 9.85065 +6281 4 12.6066 38.8468 13.8734 -16.0883 -5.26763 6.93978 +6282 6 50.1521 12.9948 0.13749 23.7903 11.3983 42.7862 +6283 4 49.8531 12.6437 41.2486 -17.3674 -16.2897 -43.7514 +6284 4 50.6811 12.2823 0.528204 -2.61001 5.26075 1.59628 +6285 6 47.8279 31.3538 27.7873 0.535952 -14.579 -21.2406 +6286 4 47.8981 31.8966 28.5732 -11.876 9.28639 5.42067 +6287 4 46.9879 31.5201 27.3031 12.1261 3.81279 14.9113 +6288 6 27.708 1.63283 7.49454 14.1634 -3.44528 -21.3886 +6289 4 26.9442 1.71926 8.04828 -16.4795 3.87106 10.0363 +6290 4 27.4331 1.03137 6.77318 -2.44435 3.14912 6.58235 +6291 6 54.8843 20.7912 16.041 -0.591057 -23.5277 -19.4313 +6292 4 54.9506 20.9946 16.9763 2.49267 -3.51754 11.2958 +6293 4 0.215527 19.8591 15.8725 -6.64294 24.8159 10.1677 +6294 6 37.4309 32.9919 34.4461 -3.01999 17.5498 0.613574 +6295 4 37.2599 32.074 34.6492 -8.98721 -14.1314 1.69718 +6296 4 36.602 33.3843 34.0789 10.8556 -9.90957 7.57788 +6297 6 19.516 39.775 6.74949 1.2991 -23.719 -0.568837 +6298 4 19.1628 39.2461 5.9771 11.6696 10.1577 21.4746 +6299 4 19.8715 39.1258 7.41882 -10.6166 14.587 -19.1486 +6300 6 32.439 2.74298 8.0597 2.15016 14.1028 28.0311 +6301 4 32.8474 3.04427 8.91221 -2.20578 -4.83758 -21.9226 +6302 4 31.6043 2.37221 8.38063 -2.27075 -4.50389 -9.9889 +6303 6 12.9757 16.0783 4.05517 0.782156 -17.4841 -11.0101 +6304 4 12.5393 15.6612 4.81952 2.97976 0.136191 -5.67644 +6305 4 13.3707 15.3387 3.55371 -3.64889 7.0956 8.52646 +6306 6 4.65115 29.9533 5.41887 4.80886 14.2508 -32.4371 +6307 4 5.0407 30.2031 4.52094 -17.5959 -12.1853 28.663 +6308 4 3.95879 29.263 5.26663 23.43 17.9812 0.878069 +6309 6 29.754 32.1152 24.0535 7.2798 7.01713 3.37681 +6310 4 30.6602 32.1649 24.4187 -11.1956 -0.828668 -6.39664 +6311 4 29.7572 31.4388 23.3746 -2.03067 -7.97912 -3.55015 +6312 6 11.8649 30.6972 33.4692 4.66278 -43.8766 26.3819 +6313 4 11.8723 29.8544 34.0435 -6.78391 38.5593 -23.2698 +6314 4 12.7601 30.7129 33.1118 -0.162199 2.5806 0.32685 +6315 6 17.3589 40.4121 27.3072 22.6925 26.1242 -9.80885 +6316 4 17.3318 41.3765 27.4299 10.8839 -2.3351 -5.50809 +6317 4 16.5554 40.1462 27.6883 -41.5002 -17.3681 16.6281 +6318 6 8.67113 4.89706 8.92484 12.0335 -9.87957 -4.1983 +6319 4 8.33733 5.39218 8.1724 -5.0195 2.6367 -1.72337 +6320 4 8.22391 5.22927 9.70847 -2.49168 4.71619 2.25155 +6321 6 39.5722 17.6819 9.57834 18.7012 -23.4437 -36.958 +6322 4 39.2207 17.6668 10.4653 -7.32211 -9.11094 11.7967 +6323 4 39.6226 16.7555 9.16114 -8.90732 35.1542 21.3272 +6324 6 31.4906 30.1663 28.5669 -18.2413 -3.40307 10.1233 +6325 4 32.2933 30.4252 28.099 2.93126 -8.695 5.25695 +6326 4 31.6493 29.3506 29.0723 8.50077 6.58979 -7.17605 +6327 6 52.667 19.2904 40.0609 -3.10376 4.72625 -3.48654 +6328 4 52.9542 18.5867 39.4362 -2.88314 13.2503 8.01058 +6329 4 53.0181 20.1618 39.7754 -0.243354 -8.89628 -7.05583 +6330 6 3.24103 7.80987 9.85575 15.4795 13.9798 -0.387217 +6331 4 3.75934 8.59525 10.1836 -13.0283 -21.6848 -11.3123 +6332 4 3.84189 7.30622 9.27659 -5.58147 6.91981 6.81825 +6333 6 23.1336 35.2172 35.587 -21.8844 -14.3383 30.559 +6334 4 23.8289 35.3646 34.9695 18.2116 12.6911 -23.5817 +6335 4 22.438 35.8962 35.5045 5.76256 0.966742 -5.52301 +6336 6 19.4997 14.0668 20.8253 -20.4482 -5.33672 -12.8711 +6337 4 19.9465 14.5101 21.5526 -0.10572 6.16799 9.82761 +6338 4 18.517 14.0876 20.9737 19.1914 1.01522 3.6393 +6339 6 23.6166 15.8675 24.0247 18.6101 -11.8924 -11.0295 +6340 4 23.7056 16.8159 24.0204 -5.88143 19.7526 4.0278 +6341 4 24.4592 15.5679 23.6279 -14.5441 0.474754 5.50536 +6342 6 0.271665 30.4941 6.10208 19.3679 10.4089 38.3983 +6343 4 55.0639 30.1609 5.24948 -13.9023 -9.5098 -30.2095 +6344 4 54.47 30.83 6.54681 -8.02886 -2.57547 -7.81581 +6345 6 4.88814 13.205 29.1223 -11.8587 -43.2127 -22.2411 +6346 4 4.78002 13.8458 29.7909 -3.08187 32.2273 31.1649 +6347 4 5.63816 13.4614 28.593 12.4558 6.3486 -8.85318 +6348 6 54.2078 27.2696 19.1963 -15.9712 -23.151 25.2067 +6349 4 0.0774591 27.3551 19.591 11.6552 0.895327 2.86932 +6350 4 54.2345 27.7605 18.3958 2.66703 17.7524 -27.3595 +6351 6 13.918 35.7451 9.18145 -1.78919 -38.7722 -17.1362 +6352 4 13.6805 34.9997 8.54227 8.11159 28.2534 18.027 +6353 4 13.9675 36.5302 8.63631 -0.993585 8.08981 -9.4946 +6354 6 5.91273 31.9181 18.8024 -12.4461 1.37758 17.74 +6355 4 5.51416 32.8097 18.9023 4.86685 -6.68339 -12.1033 +6356 4 6.30341 31.7597 17.9414 -1.0189 10.0948 -10.5031 +6357 6 5.79665 28.8753 9.48388 1.22923 1.68801 -9.18455 +6358 4 5.13151 29.3325 10.0083 -4.81051 1.68465 1.48607 +6359 4 5.29369 28.2634 8.9143 2.26517 5.17431 2.85494 +6360 6 40.1173 6.05944 9.72118 13.8961 -11.6659 -14.1698 +6361 4 40.0092 6.65032 8.94634 5.33155 -13.6 11.5113 +6362 4 40.8322 5.39707 9.49335 -23.1878 23.6737 0.508505 +6363 6 20.33 13.449 41.3936 11.1096 -0.534149 -19.18 +6364 4 21.2311 13.7006 41.7531 -26.0398 -5.61362 -19.048 +6365 4 20.2547 13.6822 40.4168 8.50391 -3.95591 26.8537 +6366 6 14.4455 21.736 27.3642 10.1345 -2.11962 18.0607 +6367 4 15.3888 21.7922 27.5976 -10.3958 0.0660495 -7.924 +6368 4 14.3649 21.6255 26.4124 4.42937 0.724974 -0.20238 +6369 6 38.7561 1.79551 30.0553 7.9914 -17.3849 -15.575 +6370 4 38.4573 2.01955 30.9195 -8.42419 6.13431 27.6354 +6371 4 38.9299 2.64677 29.6557 3.10695 8.29419 -8.65227 +6372 6 5.60526 10.8558 14.1801 -12.7318 -17.5226 5.68918 +6373 4 4.9397 11.5438 14.0518 -0.153792 0.369728 -2.18729 +6374 4 5.10481 10.0791 14.5379 11.5553 16.0131 -9.09073 +6375 6 45.3957 36.7129 27.9145 12.4213 23.5208 -28.0365 +6376 4 46.0624 36.7782 28.6036 -4.12954 -6.22049 8.27184 +6377 4 45.8092 37.2197 27.1638 -19.7894 -19.9635 17.4029 +6378 6 54.0798 35.0308 20.3994 -2.843 -1.86615 -11.5734 +6379 4 53.8804 34.0877 20.4832 1.52986 -2.36109 -0.337181 +6380 4 53.937 35.2424 19.4598 0.882668 -0.831705 10.9264 +6381 6 42.0694 14.2202 28.4717 21.1483 -3.98018 21.7174 +6382 4 41.9885 13.9669 29.4143 -10.3093 2.59547 -11.4583 +6383 4 43.02 14.3987 28.405 -3.82604 1.35242 -7.96462 +6384 6 34.8498 7.69636 26.7062 10.2576 -3.81921 3.94078 +6385 4 35.6291 7.30563 27.124 0.895866 5.46509 7.50645 +6386 4 34.5698 7.0105 26.0965 -7.64543 -1.95318 -6.87837 +6387 6 49.6738 30.7035 23.8555 -19.3272 -4.41511 -13.3992 +6388 4 50.4901 31.166 23.8286 28.3544 13.2291 -0.764283 +6389 4 49.8241 29.9642 24.4268 4.30872 -17.0733 16.2757 +6390 6 50.9008 7.796 14.1645 9.55664 -5.64416 8.78132 +6391 4 50.8079 7.01141 13.6383 2.57079 -23.1487 -4.84087 +6392 4 50.5017 8.45024 13.6177 -13.1237 27.0593 -11.2067 +6393 6 4.26801 39.4668 27.8349 5.05862 -9.29033 0.915363 +6394 4 3.69733 40.2352 27.9464 -2.13812 3.43039 0.251988 +6395 4 3.85787 38.9439 27.1453 -8.48589 -4.99062 -8.23097 +6396 6 8.74801 32.8245 8.20645 -16.3778 -23.5545 -4.64115 +6397 4 8.1587 32.1369 7.77132 15.1044 25.0089 5.08958 +6398 4 8.83862 33.6223 7.65804 -4.44885 -3.27239 -3.39484 +6399 6 52.9644 25.4956 9.38778 -23.0628 41.5097 8.07386 +6400 4 51.9653 25.4466 9.50894 36.2156 4.27363 -7.84863 +6401 4 53.1697 26.4737 9.50477 -8.20239 -39.1491 -3.41364 +6402 6 29.5595 36.7246 19.4744 18.9803 -2.04176 16.4704 +6403 4 29.6949 37.303 18.726 -4.20274 3.37351 -9.90607 +6404 4 30.4598 36.6303 19.854 -15.3589 -5.02994 0.251134 +6405 6 52.32 36.0811 25.1124 8.57954 -21.5781 -32.5589 +6406 4 53.081 35.9362 25.6725 3.50304 3.9365 6.54391 +6407 4 51.6308 36.4579 25.6293 -16.5409 10.2166 18.3955 +6408 6 21.1806 15.7021 31.1799 -1.73968 4.64344 -14.8668 +6409 4 20.7524 16.2958 30.5301 6.89899 -9.15256 14.6363 +6410 4 20.4997 15.2544 31.7027 -1.32541 3.0922 -5.22806 +6411 6 10.6615 22.4234 39.4446 2.77058 -10.3375 -21.7461 +6412 4 10.8237 22.5242 38.4595 -6.54577 -4.89624 27.0726 +6413 4 10.2823 21.5329 39.6036 8.10661 10.4602 -7.72978 +6414 6 25.1119 11.6683 22.7275 17.9584 10.1803 -43.002 +6415 4 25.2932 11.5881 23.6503 -10.3644 -4.73542 30.1579 +6416 4 24.2275 11.4525 22.4127 -3.04384 -6.16919 15.0614 +6417 6 31.7847 10.4664 2.90738 14.6232 4.92747 -25.5509 +6418 4 32.6367 10.8084 3.16838 3.35352 3.27745 17.8769 +6419 4 31.9203 10.4929 1.94425 -15.217 -5.45404 8.94289 +6420 6 52.4827 36.4345 22.1596 -7.80713 -36.8893 3.58418 +6421 4 53.0619 36.0081 21.4904 -7.85296 7.00584 7.09748 +6422 4 52.1113 35.6558 22.6625 11.8438 27.843 -13.8236 +6423 6 46.2218 40.0356 27.0002 3.00948 19.3103 18.0239 +6424 4 46.4695 39.2891 26.4839 7.60887 -23.2108 -12.3358 +6425 4 45.8298 40.6551 26.3816 -4.98516 2.75312 2.41297 +6426 6 24.0859 36.731 39.1057 28.0861 3.14637 -13.7231 +6427 4 23.7868 35.8298 38.9338 -5.18553 -0.74556 5.28182 +6428 4 23.4629 37.185 39.6652 -17.6872 -1.49015 10.8999 +6429 6 22.3474 7.42423 31.8108 -22.1464 -34.764 6.81692 +6430 4 22.3426 8.34479 32.0749 -0.491553 12.3501 5.32307 +6431 4 21.6443 6.94951 32.3421 24.5486 22.6275 -17.4273 +6432 6 14.3601 18.3609 4.10227 -5.91068 -17.6869 34.0105 +6433 4 14.0198 17.4467 4.00899 4.58845 16.3972 -3.13031 +6434 4 14.1964 18.4938 5.07185 10.0688 2.42213 -23.7444 +6435 6 27.3176 38.4584 0.118061 26.6324 1.72941 22.4386 +6436 4 26.8721 39.2229 0.514978 -6.24738 0.955789 -1.68833 +6437 4 28.1825 38.4197 0.615747 -27.5588 -2.17115 -12.0629 +6438 6 18.6641 0.153005 12.2455 -30.1585 11.9093 7.70812 +6439 4 17.6838 0.288413 12.4195 29.795 -10.6896 -3.23208 +6440 4 18.9224 41.3021 12.7767 -6.14336 -8.14908 8.56265 +6441 6 49.4289 24.9791 25.34 -2.93287 6.40986 -7.21031 +6442 4 48.5336 24.6845 25.5066 -4.79022 -10.2209 3.00881 +6443 4 49.2657 25.7332 24.7569 10.0796 0.538989 -0.302405 +6444 6 52.0657 20.2866 15.752 -30.988 -5.77477 12.2451 +6445 4 52.9883 20.4648 15.7877 30.7647 6.19501 2.10932 +6446 4 51.7487 20.318 16.6754 2.59628 0.707672 -8.61894 +6447 6 49.6694 15.6466 38.5033 -2.36871 5.8496 0.21755 +6448 4 49.1634 15.9354 37.7317 2.81773 -6.75889 -8.88584 +6449 4 49.3364 16.2327 39.1899 -1.1635 1.82265 11.9188 +6450 6 15.9209 23.7098 13.4125 14.0576 3.0382 28.6395 +6451 4 16.4576 23.7581 14.2247 -6.14337 -14.5589 -15.9509 +6452 4 15.4928 24.5639 13.4473 -12.8057 7.70559 -12.0572 +6453 6 14.3535 29.1644 14.3158 -5.44214 8.41065 -10.6214 +6454 4 14.1107 29.5404 13.4323 4.3831 -8.60004 22.5031 +6455 4 14.1668 29.874 14.9595 1.02369 -3.68708 -8.8215 +6456 6 30.4209 19.8501 16.8941 13.513 -29.8099 -4.40702 +6457 4 30.8419 19.6061 17.7309 -1.16118 4.00396 0.0836579 +6458 4 29.8867 20.6126 17.0073 -13.0379 22.0094 6.56408 +6459 6 21.3171 21.0315 23.1347 13.77 4.04154 19.3244 +6460 4 22.2214 21.2364 23.4619 -15.8088 -1.32345 -6.31481 +6461 4 20.7299 21.1568 23.8987 5.07857 1.54253 -3.54042 +6462 6 32.3393 0.431439 25.2563 20.1104 -9.0179 2.05206 +6463 4 32.3376 0.357033 24.2893 -5.83171 4.85221 4.50445 +6464 4 31.4939 0.740536 25.5658 -20.5297 5.12544 -3.04931 +6465 6 26.1412 32.4208 27.5133 11.9844 8.82666 12.5058 +6466 4 25.6297 33.2181 27.3271 -3.7928 0.326337 -6.17907 +6467 4 25.9506 31.7475 26.8638 -6.12498 -3.36782 -14.5181 +6468 6 31.6886 23.0183 41.4596 0.904697 7.64904 11.3452 +6469 4 32.5758 22.6752 41.6838 -11.075 0.532718 -2.08438 +6470 4 31.0649 22.7115 0.227606 5.71652 1.16966 -4.3825 +6471 6 54.3662 17.838 10.7289 1.16641 13.6113 28.4031 +6472 4 53.5784 18.2682 10.4091 -15.835 11.3767 1.3744 +6473 4 54.5574 17.2244 10.05 12.0924 -25.2322 -22.7117 +6474 6 15.4007 28.5656 8.62044 -26.1749 5.76845 -41.3303 +6475 4 14.7273 28.9702 8.01425 13.7656 -2.21873 23.1298 +6476 4 15.8479 27.9621 8.001 5.22436 1.48231 12.0756 +6477 6 21.9302 22.318 27.6758 1.68517 -22.7815 -10.3197 +6478 4 22.2029 23.2377 27.6948 5.32233 7.77922 8.4028 +6479 4 21.9507 21.9579 28.5708 1.77406 4.33165 6.10734 +6480 6 2.9439 17.0434 8.14058 1.94164 -24.3442 -12.3304 +6481 4 3.71771 17.0381 7.53295 -10.9103 8.58946 10.7103 +6482 4 2.9095 17.8301 8.67828 12.1388 15.179 1.9509 +6483 6 27.5776 18.2769 3.9771 26.0492 -34.2565 5.18616 +6484 4 26.8914 18.9079 3.85686 -19.1066 25.6869 -8.0303 +6485 4 28.3968 18.6065 3.57961 -12.2542 3.89161 2.52414 +6486 6 24.7648 24.5394 8.45172 0.675902 5.99664 -6.73781 +6487 4 25.0691 23.6382 8.29185 0.995795 -2.08458 0.0885467 +6488 4 24.6379 24.6158 9.40394 1.7631 1.80546 -0.516948 +6489 6 41.9985 30.4652 13.7873 -12.418 22.2399 8.0521 +6490 4 42.948 30.5766 13.6065 -4.54142 -18.1038 -0.632901 +6491 4 41.6543 29.5567 13.7855 17.2179 -0.450275 -1.52495 +6492 6 15.7003 34.688 41.5836 22.5583 -4.71252 2.77114 +6493 4 16.4414 35.3131 41.7067 -7.89455 1.74939 1.29748 +6494 4 14.9091 35.1782 41.7999 -10.5684 8.94915 5.66738 +6495 6 11.14 19.7709 40.5827 8.16812 -24.8495 -13.7269 +6496 4 12.099 19.6958 40.4335 -6.97557 5.6239 6.72769 +6497 4 10.8269 18.8658 40.3418 -4.09458 16.1616 8.77151 +6498 6 47.4994 34.5266 14.3059 -7.29954 -13.2064 -47.3862 +6499 4 46.9486 35.2618 14.0194 -1.26876 14.2822 14.9014 +6500 4 47.5134 34.0178 13.447 14.161 -1.19014 30.6955 +6501 6 12.4113 26.9599 28.4986 7.53387 -39.615 -11.3807 +6502 4 13.2389 26.8759 29.0383 -9.69033 -7.26437 -10.917 +6503 4 12.3547 26.143 27.8911 8.77392 33.3418 27.7102 +6504 6 27.6324 16.2078 39.8226 -15.7166 38.3334 10.2244 +6505 4 27.1738 15.4871 40.2515 -0.529449 -16.0233 0.418904 +6506 4 28.2783 15.8881 39.2072 13.4358 -18.0852 -11.4488 +6507 6 33.41 31.2223 27.2648 1.06056 32.1352 -34.8736 +6508 4 34.1408 31.8147 27.4795 4.37007 -7.45055 8.12396 +6509 4 32.9956 31.7298 26.5244 2.74339 -19.701 12.9858 +6510 6 39.1079 39.5697 31.9277 -2.55925 2.09297 0.92959 +6511 4 38.7672 39.6549 31.0188 2.43701 -1.71218 7.87361 +6512 4 38.6143 40.212 32.4659 5.60044 -5.69156 -1.85126 +6513 6 22.8777 16.5449 19.9566 -5.65986 -8.80894 -1.36967 +6514 4 23.3352 15.8067 20.4264 -14.7096 4.17994 -10.0586 +6515 4 22.0919 16.2116 19.4632 15.4216 -6.99735 9.66589 +6516 6 23.9693 21.8661 10.5894 -36.2244 3.36606 3.40233 +6517 4 22.9782 21.9097 10.6297 20.8239 3.29656 -5.85881 +6518 4 24.1356 21.2379 11.286 10.3432 -8.66819 12.8402 +6519 6 40.1777 25.441 2.79106 -10.2872 18.2283 6.37262 +6520 4 40.1705 25.0132 3.63888 8.49445 -17.5146 10.0011 +6521 4 39.7592 26.2809 3.01477 -1.02299 2.45309 -8.63041 +6522 6 15.0237 19.7749 9.41859 -29.0071 17.4399 5.80075 +6523 4 14.7228 20.7104 9.1599 7.38 -34.1593 9.70733 +6524 4 14.2459 19.2857 9.84339 25.5779 21.3804 -17.4983 +6525 6 7.16152 24.8628 0.123297 -7.02966 -3.56682 11.7049 +6526 4 7.96668 24.8036 41.5398 15.214 -7.46464 -23.6733 +6527 4 7.46323 25.2953 0.914133 -6.27594 4.44234 13.0485 +6528 6 43.3927 10.9201 31.3407 25.4071 10.106 7.84859 +6529 4 43.8098 10.8609 30.45 -7.40798 -0.791197 19.4909 +6530 4 44.1598 10.9733 31.9767 -21.009 -0.343387 -21.8186 +6531 6 13.8353 19.068 27.8558 -6.19586 12.3763 0.85665 +6532 4 12.975 18.7858 28.1864 -1.64107 2.23065 2.52451 +6533 4 13.8413 20.053 27.8412 2.88957 -13.8419 -2.19198 +6534 6 3.4728 19.5924 9.6022 -44.5705 9.69836 1.75794 +6535 4 2.70361 20.0095 10.0844 20.5969 -13.9146 -9.89239 +6536 4 4.25765 19.8234 10.0844 13.5534 0.0599395 5.99295 +6537 6 51.0213 19.4268 7.70955 2.43945 12.0622 -23.2725 +6538 4 50.6325 20.2627 7.28999 21.6228 -31.5555 10.1722 +6539 4 51.8004 19.115 7.16203 -27.7652 18.9123 7.69536 +6540 6 42.2139 2.59999 10.4154 11.3377 -7.01405 -0.847173 +6541 4 43.144 2.57533 10.7556 -19.516 1.89174 -10.2127 +6542 4 42.1979 2.39197 9.45142 9.27815 6.14572 20.7298 +6543 6 30.7794 6.42968 35.1975 -13.4378 -7.3385 -2.08895 +6544 4 29.8146 6.43175 35.3648 9.73054 -4.02703 -1.93701 +6545 4 31.052 5.50707 35.0427 -6.67101 6.52405 0.860042 +6546 6 52.8733 36.9495 18.5906 -4.95733 10.1612 -6.16245 +6547 4 51.9909 36.5548 18.5738 -2.549 -5.51132 1.40056 +6548 4 52.7192 37.8514 18.247 7.64894 -10.0112 4.74408 +6549 6 44.2058 6.2999 1.04709 5.21291 8.10008 11.2107 +6550 4 44.5368 6.97198 1.69742 -2.24215 -10.2401 -12.34 +6551 4 44.9393 6.09517 0.464894 1.54959 1.89788 1.1267 +6552 6 42.1369 38.61 31.1886 17.67 -9.24899 26.4806 +6553 4 41.7623 38.8803 30.3687 -14.3725 6.55505 -24.001 +6554 4 41.498 38.8614 31.8609 -3.32676 4.75778 -0.202389 +6555 6 43.7164 12.7972 9.05712 5.81528 3.72875 -30.711 +6556 4 43.3247 13.6946 8.89573 9.87346 -21.9812 3.16194 +6557 4 44.14 12.4709 8.19462 -12.6006 16.8915 32.7492 +6558 6 13.3844 0.443398 6.51083 -17.4423 24 5.83044 +6559 4 13.1471 1.18968 7.12521 11.9969 -17.0568 -16.1514 +6560 4 13.404 0.824606 5.60344 -0.330864 -2.32474 10.3957 +6561 6 16.1322 13.2809 10.2756 -7.67495 0.483234 -7.74316 +6562 4 16.9315 12.7781 10.4995 -2.28882 -8.98658 -2.43525 +6563 4 15.4389 12.669 9.92885 16.2568 3.72445 6.60733 +6564 6 1.59909 8.47465 4.69565 -12.106 -24.0688 17.9122 +6565 4 1.97809 9.06493 4.05503 13.7499 12.9224 -12.6029 +6566 4 2.17818 8.51684 5.47441 1.43398 4.73372 -5.14276 +6567 6 37.2847 1.71984 10.5234 11.0189 -27.5723 -13.4042 +6568 4 37.2468 2.67416 10.4778 -4.00861 9.27523 10.0347 +6569 4 36.8996 1.35439 11.335 -2.27729 16.2243 3.90618 +6570 6 53.8329 9.87891 17.6846 -38.3798 -30.924 7.14602 +6571 4 54.5301 10.0186 17.0634 18.0368 1.02749 -18.7159 +6572 4 53.3473 9.06138 17.3773 12.8854 20.2391 7.24153 +6573 6 45.4804 30.6107 15.8042 -8.04753 0.598448 7.23065 +6574 4 44.8245 31.2304 16.205 12.7241 -16.0174 -7.51778 +6575 4 45.2045 29.6903 15.9459 -0.384376 11.4708 0.631615 +6576 6 39.9212 16.643 33.8508 -27.7636 -7.17353 -19.4615 +6577 4 39.1766 17.1755 33.458 21.1378 -12.4278 10.7513 +6578 4 39.8244 15.7487 33.4296 5.23768 21.8708 14.061 +6579 6 32.8655 24.7639 27.9361 20.284 59.6053 -7.49862 +6580 4 33.6165 25.1458 28.4374 -8.60268 -19.6727 -0.650124 +6581 4 32.6313 25.5876 27.4183 -1.69816 -34.155 10.7383 +6582 6 7.87466 31.6143 24.1101 1.9117 20.6925 26.3443 +6583 4 7.66972 30.8573 24.7192 5.27436 26.873 -8.7819 +6584 4 7.9908 32.4716 24.6533 -12.57 -44.6195 -20.0842 +6585 6 43.5378 41.3358 15.8218 9.28004 -2.58796 -1.50951 +6586 4 43.1443 0.2957 15.6997 -2.19094 2.48586 -2.7957 +6587 4 44.4004 41.3722 15.3768 -7.99823 -0.449815 2.36698 +6588 6 20.0371 29.5453 33.205 3.08504 -20.5033 -11.6211 +6589 4 20.9096 29.2965 33.5637 -2.90058 10.2459 9.35691 +6590 4 19.6251 30.2513 33.706 8.84517 7.80605 8.87396 +6591 6 43.4117 21.4438 18.6347 -11.1342 -15.0059 14.8538 +6592 4 43.0276 21.2687 19.5098 8.56326 4.46648 -0.801958 +6593 4 42.8532 20.9111 18.0542 1.01153 2.95656 -9.2223 +6594 6 3.44653 19.1197 18.4217 23.6769 1.99723 9.81042 +6595 4 3.20802 20.045 18.3207 -2.32682 2.96104 -2.33529 +6596 4 2.63398 18.6303 18.3598 -12.7596 -8.76931 -2.32568 +6597 6 41.6678 38.1102 16.3244 12.531 -42.2252 -39.0953 +6598 4 41.9368 37.3879 15.641 -15.3799 38.9729 30.6603 +6599 4 42.3331 38.0554 17.0146 -0.0757724 1.18921 2.99625 +6600 6 7.55561 36.3978 10.4983 -3.44092 15.1931 -1.45671 +6601 4 6.72339 36.2337 10.0108 12.3142 -8.52859 4.51616 +6602 4 7.946 35.5335 10.7116 -10.6452 2.04557 -4.50299 +6603 6 36.2515 19.1074 34.8142 -43.7142 -17.0801 -27.3746 +6604 4 35.3817 19.3303 34.3863 23.1726 -6.06315 12.306 +6605 4 36.4633 19.8781 35.3097 10.3 22.3537 14.1292 +6606 6 53.5678 24.9372 12.6442 30.4342 18.5181 -32.2976 +6607 4 53.8348 25.8921 12.6266 -11.9077 -21.6197 10.5864 +6608 4 54.0165 24.5977 11.8224 -16.4724 -4.37861 26.9125 +6609 6 31.6766 10.443 21.0806 4.21881 -9.06253 -2.47208 +6610 4 31.4001 9.76622 21.7243 -7.70504 9.2495 -8.08332 +6611 4 30.9288 10.6617 20.4921 1.78432 -8.02731 8.28605 +6612 6 18.1094 28.7798 17.1891 14.7524 22.0605 -19.6834 +6613 4 19.0758 28.769 16.9872 -20.2742 -2.10771 9.28657 +6614 4 17.7731 29.5847 16.7123 5.43167 -23.0331 15.3038 +6615 6 21.675 18.2354 36.8765 16.12 -15.5286 8.52342 +6616 4 22.5529 17.9072 36.565 -22.4082 10.693 4.11156 +6617 4 21.5572 17.762 37.7329 -6.04816 8.67317 -10.9669 +6618 6 25.0658 19.0188 34.2159 -51.8076 2.97265 19.7815 +6619 4 24.747 18.4039 34.9114 5.38902 10.2451 -10.362 +6620 4 25.8774 18.6629 33.96 52.7001 -22.9877 -15.275 +6621 6 15.5692 13.0234 5.56242 -6.58245 2.44228 -13.4315 +6622 4 15.9945 13.4237 6.33643 -0.981395 -11.5063 2.18089 +6623 4 15.4281 12.0558 5.58603 5.20341 13.6823 8.40676 +6624 6 54.4716 41.6235 14.8012 14.2089 2.8312 2.80672 +6625 4 54.7869 41.5367 15.7234 -10.706 -4.16636 -8.71187 +6626 4 53.6678 41.1066 14.6963 -6.31993 -3.99892 7.53898 +6627 6 1.6781 26.4654 31.3743 5.67012 -21.4195 51.4057 +6628 4 2.55869 26.331 31.7713 -6.41431 -1.4007 -7.54986 +6629 4 1.81482 26.7235 30.4972 11.6805 15.9936 -52.9786 +6630 6 32.3382 37.285 29.6856 -26.7217 17.5069 7.43983 +6631 4 31.5807 37.8924 29.918 20.5429 -15.6126 -5.39856 +6632 4 33.128 37.6701 30.0913 2.74033 -1.11204 0.131524 +6633 6 52.7155 21.0369 22.8986 -26.6856 13.1044 -7.83906 +6634 4 51.927 21.5218 22.5308 17.9584 -10.8856 16.9396 +6635 4 53.1096 20.6236 22.131 10.0871 -9.76004 -3.40095 +6636 6 32.7546 28.5936 40.5151 -16.005 5.57574 20.6704 +6637 4 31.9696 29.0914 40.2712 1.08408 5.35728 -15.103 +6638 4 32.4826 28.2925 41.3957 13.2257 -7.23298 -6.66392 +6639 6 23.6064 32.0719 16.3529 6.2601 0.887785 0.577407 +6640 4 24.375 31.9361 16.9584 -22.6405 4.1158 -3.2487 +6641 4 22.7879 32.3052 16.8361 12.3926 -5.56708 -0.502672 +6642 6 37.5201 9.16809 29.9792 -2.73778 -7.47015 7.66604 +6643 4 36.7801 8.78215 30.4957 3.311 11.363 -11.2805 +6644 4 37.2059 9.98527 29.541 -5.1069 -9.85197 8.55889 +6645 6 2.27705 24.391 14.5477 -18.8311 -23.8216 -15.5117 +6646 4 1.75426 24.0938 15.3142 10.0576 11.8704 2.19803 +6647 4 1.95568 23.7778 13.8474 11.5886 17.7779 11.9828 +6648 6 27.3753 28.7961 24.7726 7.21008 -25.2057 -20.8265 +6649 4 27.1644 28.4274 25.6317 -2.92196 -0.0765173 10.3399 +6650 4 27.4291 28.0161 24.1505 1.02404 24.316 14.9 +6651 6 16.7879 2.56531 14.3086 11.9129 14.2285 -1.69346 +6652 4 17.7185 2.38196 14.3175 13.0278 5.32386 8.84309 +6653 4 16.4775 1.81817 13.8231 -22.7045 -15.6449 -12.1127 +6654 6 21.8022 39.8027 36.8001 40.4582 11.674 1.33338 +6655 4 22.755 39.5599 36.9347 -17 12.4394 -0.288792 +6656 4 21.461 38.9709 36.5396 -21.7153 -28.8447 -11.0269 +6657 6 14.0716 6.47232 41.542 21.0202 -14.2424 -6.97231 +6658 4 14.9696 6.10406 41.5939 -1.81915 -4.72532 -7.76656 +6659 4 14.0403 6.99701 0.421866 -13.8031 9.98176 13.4178 +6660 6 14.5555 16.5106 9.31543 20.3876 4.44524 4.12907 +6661 4 15.4025 16.5964 9.78828 0.864554 -6.42184 -12.9633 +6662 4 13.9847 17.046 9.86181 -12.8914 3.93145 3.80898 +6663 6 8.66171 23.4817 30.5575 -0.244333 -0.896371 32.8135 +6664 4 9.54353 23.6001 30.2398 18.7576 4.73722 -27.2602 +6665 4 8.85707 23.3999 31.5064 -16.6456 -3.41855 -0.290363 +6666 6 37.6497 2.07069 20.0046 29.2824 -26.1096 14.9164 +6667 4 37.0584 2.2163 19.2662 -13.6051 13.4744 -1.64318 +6668 4 37.4656 2.68422 20.7276 -9.488 6.31449 -9.7769 +6669 6 42.7264 7.54802 8.0174 22.2735 -23.3375 63.966 +6670 4 43.1898 7.96838 7.30926 14.9789 10.8108 -11.9713 +6671 4 43.3711 7.43923 8.8454 -34.4126 10.1207 -51.4479 +6672 6 38.5672 29.6578 6.85692 25.3422 5.29964 1.58487 +6673 4 38.5311 29.2984 7.75245 -9.71234 0.328663 -2.10015 +6674 4 37.7248 29.5682 6.41889 -15.2832 -4.18317 0.54199 +6675 6 42.5348 15.7114 39.7967 1.15785 13.3588 -25.5786 +6676 4 42.7129 16.6429 39.5831 1.88136 -1.51067 11.9166 +6677 4 42.2359 15.3735 38.9271 3.70013 -4.77916 17.2749 +6678 6 19.8546 7.43685 22.0566 -22.5975 2.81071 25.7956 +6679 4 19.2803 8.13273 21.6746 8.521 -7.13733 1.21439 +6680 4 19.4015 7.21173 22.9242 12.7412 8.86068 -31.9054 +6681 6 27.421 3.23371 12.5304 27.0524 21.0752 -24.489 +6682 4 28.3367 3.35644 12.1327 -27.9555 -7.8832 14.1518 +6683 4 27.3543 2.31638 12.8154 4.42645 -1.52034 -0.990676 +6684 6 34.4011 6.50186 34.3664 -16.3424 -2.90191 9.94761 +6685 4 33.6712 7.15225 34.4215 6.78416 -7.62851 1.00734 +6686 4 34.1394 5.7575 34.9538 2.66911 12.7001 -5.69623 +6687 6 9.88701 27.9536 39.7574 38.1218 -1.21446 9.36845 +6688 4 10.8313 27.9815 40.1009 -35.4969 -5.93471 -11.3457 +6689 4 9.7403 28.8357 39.397 -3.9481 4.17466 -3.11552 +6690 6 50.5681 22.1235 6.40489 -3.33101 1.51672 6.50125 +6691 4 51.5163 22.3536 6.46403 -14.0562 3.33212 10.0382 +6692 4 50.0608 22.5915 7.10741 15.6039 -2.37345 -9.267 +6693 6 47.1098 11.477 30.0359 32.4056 2.61276 18.961 +6694 4 47.3696 10.9259 30.8115 -10.3246 7.95021 -16.9085 +6695 4 46.3045 11.1726 29.6407 -20.48 -14.5539 -1.24473 +6696 6 25.9367 28.4654 9.80931 -8.38409 -27.2904 31.5361 +6697 4 26.8395 28.2564 10.1264 -14.1867 1.81997 -4.27567 +6698 4 25.3175 27.9176 10.3882 19.4096 21.4407 -17.1039 +6699 6 35.4417 36.6052 19.4431 3.65383 9.51374 12.5698 +6700 4 35.4442 36.5892 20.4356 4.35023 4.13201 -20.4161 +6701 4 36.0823 37.2978 19.1702 -7.18083 -5.57131 7.61291 +6702 6 39.0947 17.861 12.3005 -1.37104 18.7141 6.38745 +6703 4 39.0516 18.8013 12.5757 6.4741 -5.57949 -8.41576 +6704 4 38.3925 17.481 12.8252 -9.64523 -10.3587 5.73293 +6705 6 2.67895 27.1328 2.39169 -0.469231 -1.96621 -7.87892 +6706 4 2.01695 27.5866 1.84113 6.06579 -3.44887 4.00529 +6707 4 2.54603 27.3828 3.31988 1.36543 -1.57126 -4.01383 +6708 6 12.3125 32.2183 21.5204 7.73608 31.3279 -34.5621 +6709 4 12.8754 32.1648 22.302 -15.5368 -9.13091 6.69049 +6710 4 11.4514 31.7997 21.5885 -0.151568 -8.94455 23.3893 +6711 6 32.8824 32.3641 8.46179 -18.8611 4.30442 3.1153 +6712 4 33.4241 32.9657 8.96292 17.2175 7.79223 5.74753 +6713 4 32.0088 32.7748 8.50666 0.635289 -6.40729 -7.5616 +6714 6 12.649 6.44414 31.9754 -2.83404 4.50046 10.0363 +6715 4 13.204 6.32185 31.2101 8.19857 -2.9014 -11.0209 +6716 4 11.7563 6.235 31.704 -2.09981 -3.08597 -3.85403 +6717 6 41.3663 27.7408 14.044 -7.1512 -14.0341 -18.9391 +6718 4 41.8178 27.3798 13.2339 -12.2472 13.3456 19.5442 +6719 4 40.4043 27.5413 13.9741 19.5004 0.843126 1.31278 +6720 6 6.61204 16.505 25.4358 4.38086 10.1107 -4.22872 +6721 4 7.40634 15.95 25.3995 -3.52048 -0.326181 -5.74655 +6722 4 5.93615 16.0015 24.9584 5.4209 -2.01242 3.85811 +6723 6 21.7595 39.2992 13.3504 -47.5104 6.20728 42.9111 +6724 4 22.3466 39.2605 12.6295 26.4998 6.28224 -34.1528 +6725 4 21.7095 40.2078 13.7281 10.6984 -16.5323 -14.9329 +6726 6 34.8487 6.01484 6.95222 -29.6963 0.326386 -14.1862 +6727 4 33.862 5.88861 6.88689 25.1099 2.0969 11.0318 +6728 4 35.0754 6.24807 6.0365 6.49139 -1.48305 5.74594 +6729 6 33.0274 30.4243 33.1708 -20.2868 -13.6057 -33.0226 +6730 4 32.107 30.5622 32.8069 24.6222 -1.48625 15.7647 +6731 4 33.1252 31.0225 33.8918 -2.19017 18.1524 16.6028 +6732 6 15.459 32.4153 12.1907 25.026 -14.7999 12.6103 +6733 4 16.3707 32.0454 12.2858 -22.5133 7.43237 -2.39957 +6734 4 15.4871 32.8857 11.3664 4.63911 10.1509 -16.175 +6735 6 12.6896 26.6018 21.3639 -15.0944 -25.6853 -2.70918 +6736 4 11.948 26.0906 21.6799 0.937138 -29.673 -19.3981 +6737 4 12.542 27.2759 21.9777 19.0907 58.813 21.5342 +6738 6 47.0229 36.3064 29.9951 -7.32095 -4.41829 24.4392 +6739 4 47.4263 37.0889 30.4354 -10.9743 -13.05 -1.23566 +6740 4 46.4286 35.8162 30.6445 23.161 23.2616 -16.2608 +6741 6 0.29284 12.714 23.4069 -35.5625 7.7859 6.41586 +6742 4 0.591011 11.8915 23 -3.04289 0.952694 -0.179009 +6743 4 54.2726 12.6526 23.4069 36.7156 0.482893 -0.227565 +6744 6 54.1717 18.9252 21.5683 -50.0663 20.0699 0.290361 +6745 4 -0.00468748 18.6783 21.9698 30.2345 -16.5238 -1.58257 +6746 4 54.0846 18.73 20.626 15.626 -5.42297 0.74208 +6747 6 25.7258 24.2992 23.7444 19.803 -45.4072 -0.235584 +6748 4 25.1532 23.5493 23.4006 14.0979 28.9064 13.4272 +6749 4 26.557 23.8171 24.0636 -29.432 23.3848 -10.2309 +6750 6 11.8983 29.0288 26.8736 6.09277 -0.515715 3.71925 +6751 4 12.595 29.6797 27.0784 -3.35093 -5.68029 1.25498 +6752 4 11.9864 28.3255 27.5444 1.01315 10.8055 -7.75858 +6753 6 47.9911 35.8567 10.6981 8.08413 -4.02984 -21.6227 +6754 4 48.7745 35.7734 10.1229 -13.6418 -1.85084 -2.1863 +6755 4 48.3792 36.2903 11.4463 -1.30569 7.34959 21.4512 +6756 6 47.672 29.8438 36.9511 38.562 -32.0587 -16.7646 +6757 4 48.1514 29.311 36.2244 -26.8687 25.3781 26.6073 +6758 4 46.9232 30.3209 36.5927 -0.690739 -0.634879 -8.58348 +6759 6 7.33835 12.3416 10.615 -8.89583 -3.33234 -10.1121 +6760 4 7.22469 12.7824 9.73793 -1.24183 -8.23722 19.221 +6761 4 6.50851 12.5236 11.1156 17.4449 -0.896679 -14.5349 +6762 6 52.929 15.961 4.90278 -10.2898 -1.28264 -8.50781 +6763 4 53.0348 16.1145 3.95774 -1.18717 -0.815743 4.35872 +6764 4 53.806 16.0238 5.26597 15.814 -0.370642 9.21047 +6765 6 10.6777 16.9586 34.6035 -55.1347 -38.7426 5.67968 +6766 4 10.8984 16.7766 35.5088 23.7364 14.024 15.8473 +6767 4 9.8802 16.3472 34.5582 30.0556 27.9196 -18.3163 +6768 6 25.1377 31.056 36.0048 1.42921 -10.848 -28.6765 +6769 4 25.7744 31.7772 36.0714 -0.417948 1.95283 3.18329 +6770 4 25.3475 30.6244 35.1463 -8.66047 8.51414 18.9355 +6771 6 34.0941 21.8921 41.4705 -2.59948 8.49748 21.8065 +6772 4 33.8376 21.0023 41.2487 -0.891159 -17.6747 -3.00217 +6773 4 34.5263 22.2081 40.6953 10.3371 11.5397 -24.1167 +6774 6 15.7674 30.0637 1.25444 19.4532 4.17941 -23.0135 +6775 4 15.204 30.4318 1.91689 -16.4157 4.77211 21.8875 +6776 4 16.1981 30.8773 0.915598 -5.77798 -19.2538 1.08217 +6777 6 29.5177 27.8662 16.6069 -21.9867 -20.8772 26.8051 +6778 4 29.4575 26.8938 16.8925 2.72258 42.9501 -5.19299 +6779 4 28.8337 28.3532 17.1557 16.905 -14.8206 -13.8895 +6780 6 39.6418 9.77683 0.55649 6.97543 15.8838 23.3716 +6781 4 40.1108 10.6055 0.868863 -11.4024 -23.0197 -7.66085 +6782 4 39.4946 9.23542 1.36828 3.21978 8.9832 -14.2415 +6783 6 1.52158 31.8692 16.4183 -13.8984 7.04184 27.8471 +6784 4 2.05742 32.2974 15.7673 16.5414 8.9668 -16.2997 +6785 4 1.54493 30.9444 16.2035 3.31157 -20.7597 -8.56027 +6786 6 8.73651 39.8559 25.0424 -4.76165 -15.5453 0.0774869 +6787 4 8.05377 39.648 25.6948 0.177415 -5.7342 -2.33302 +6788 4 8.86744 40.7877 25.1714 9.39418 20.2019 -3.50565 +6789 6 42.3206 10.2864 9.76098 2.95973 19.1246 -1.63703 +6790 4 42.201 10.133 10.7061 4.21692 -0.996774 -0.328573 +6791 4 42.7677 11.1578 9.6855 -5.09192 -13.1904 -0.0451331 +6792 6 13.2407 7.61713 1.96996 -7.39862 -1.41628 8.88927 +6793 4 13.9913 7.91748 2.51852 -7.45732 -2.50241 0.703823 +6794 4 12.5579 7.21318 2.54911 15.3337 9.06064 -6.21655 +6795 6 18.7418 40.0591 14.2229 14.6643 6.60726 6.61579 +6796 4 19.3344 39.8885 14.9901 -13.3575 3.17545 -12.3588 +6797 4 17.9636 39.4956 14.2872 3.6042 -5.87931 7.54738 +6798 6 20.1073 14.0529 38.5598 27.8117 -61.2518 1.76132 +6799 4 20.1641 13.6472 37.6602 -4.05869 13.902 17.7453 +6800 4 19.784 14.907 38.4293 -21.3136 56.4597 -12.4562 +6801 6 22.6529 28.8869 34.0687 6.58134 -12.6264 20.4136 +6802 4 23.051 28.2341 33.486 -0.980474 2.102 -8.59088 +6803 4 22.967 28.5961 34.9503 -6.50134 7.38476 -6.63172 +6804 6 22.6736 4.71248 5.24178 -0.00794307 -2.96021 -16.86 +6805 4 22.1728 3.90748 5.48978 2.26378 16.1145 9.27739 +6806 4 22.7088 5.35566 5.95806 -4.05577 -5.29394 11.9552 +6807 6 23.6374 34.0001 38.3917 50.061 26.1352 -20.3518 +6808 4 22.8137 33.6238 38.6177 -41.7704 -11.5062 -0.965889 +6809 4 23.6153 34.3835 37.4812 -9.56218 -11.3792 16.4738 +6810 6 48.3816 21.3644 17.2759 -0.964958 21.4078 15.1884 +6811 4 48.1603 22.346 17.2347 5.31328 -30.3781 -7.15015 +6812 4 48.2799 20.9337 16.4123 -2.86285 15.3202 1.32987 +6813 6 11.5786 11.0066 8.63803 -22.8025 30.9503 41.2381 +6814 4 11.6342 10.2487 9.24135 6.24209 -4.12245 -6.65597 +6815 4 11.0653 11.6976 9.17674 20.0011 -23.9124 -25.5895 +6816 6 40.098 28.1667 33.502 25.4322 5.13826 0.328547 +6817 4 41.0532 28.3457 33.4282 -8.43417 -7.39989 8.78785 +6818 4 39.8078 28.5143 32.6608 -12.8477 1.2165 -2.93222 +6819 6 47.3852 25.6796 5.28879 12.5804 32.9376 -10.0311 +6820 4 46.4546 25.5561 5.13624 -16.8804 -10.2001 -0.268496 +6821 4 47.5232 26.6241 5.03253 2.87445 -14.5067 3.75712 +6822 6 21.6604 35.221 23.9985 9.0652 15.9564 -12.6156 +6823 4 21.5339 34.4977 24.6161 5.50034 -7.33202 6.93593 +6824 4 22.5891 35.5406 24.0132 -10.9025 -9.97729 6.37443 +6825 6 8.25067 41.5023 8.40693 4.57396 0.593767 -7.67714 +6826 4 8.14583 40.8128 7.73311 1.23406 2.32353 -0.157563 +6827 4 7.86929 41.1416 9.20784 -2.18245 3.41182 6.12515 +6828 6 16.4756 31.0916 22.2208 -15.8048 -5.76047 -3.57767 +6829 4 16.9823 30.8797 21.4186 0.224111 -1.11381 3.57708 +6830 4 17.0871 31.1495 22.9566 10.3822 -1.94934 1.40451 +6831 6 54.7052 0.441622 28.3216 30.4392 7.42547 7.16367 +6832 4 0.670225 0.280878 28.2941 -2.60978 -25.0778 -11.1355 +6833 4 54.7831 1.35385 28.5964 -22.0828 12.0381 3.63841 +6834 6 48.4365 15.3814 4.18175 16.1137 -59.8395 -8.29881 +6835 4 49.2486 15.0627 4.66696 -19.7577 20.5705 -9.22457 +6836 4 48.202 14.5739 3.61717 1.65501 39.0327 16.4105 +6837 6 34.3447 6.98096 40.4233 28.1894 -26.1309 -0.966046 +6838 4 33.5941 7.1072 39.8443 -1.28272 -2.58724 -7.46065 +6839 4 35.0352 6.39393 39.9745 -30.768 20.5054 8.50532 +6840 6 41.3452 3.36617 16.9999 -11.8967 -16.9054 2.63506 +6841 4 41.0249 2.72492 17.6694 2.1854 6.18106 -7.89089 +6842 4 41.9449 3.92974 17.49 7.08552 9.22633 4.28017 +6843 6 48.4488 20.6937 14.5344 36.1561 -40.2628 27.2518 +6844 4 47.9962 21.3635 14.0898 -25.7182 45.1623 -29.349 +6845 4 49.3977 20.8911 14.4834 -7.22111 0.680744 -3.09477 +6846 6 52.5006 28.1422 37.1181 -0.438891 10.9489 1.55023 +6847 4 53.461 28.2559 37.0441 -2.53591 -5.73983 -7.32344 +6848 4 52.1579 27.9957 36.2188 6.05301 2.29627 6.02383 +6849 6 53.8778 18.5596 18.7916 -16.4261 -54.6782 2.06415 +6850 4 54.6924 18.1462 18.492 5.89253 -2.608 -0.931268 +6851 4 54.0684 19.4623 18.7843 11.279 55.5152 0.463912 +6852 6 40.9954 39.1455 28.7887 -28.6383 -4.85259 53.4888 +6853 4 41.3933 39.2419 27.9663 30.849 7.00679 -57.5311 +6854 4 40.0484 39.2316 28.6375 -4.32997 -1.25138 -0.266272 +6855 6 38.2708 8.75593 24.2289 27.2886 -4.9888 -5.43324 +6856 4 39.2171 8.59021 23.9715 -26.3742 3.09491 7.04217 +6857 4 38.3303 9.34105 24.9905 -3.83131 2.71498 5.53525 +6858 6 2.99948 29.1469 9.63392 26.6909 -34.1608 2.5373 +6859 4 2.51216 28.7995 8.89273 -4.75194 -2.8028 -9.24178 +6860 4 2.58111 29.9575 9.82954 -15.8869 33.6035 13.3424 +6861 6 27.5773 29.2771 18.3181 4.27818 -11.5166 33.1226 +6862 4 26.7531 29.1546 17.8331 -9.3021 -0.872639 -4.78576 +6863 4 27.3558 28.9731 19.2647 9.0806 12.9475 -44.783 +6864 6 11.8527 21.1658 10.1208 3.44892 -32.1211 19.512 +6865 4 12.1978 22.0146 9.89711 8.39983 22.4635 -8.03232 +6866 4 12.4593 20.8304 10.8135 -12.0936 9.66798 -13.0295 +6867 6 16.8988 32.3014 0.299949 1.29982 1.68058 -0.586211 +6868 4 17.7043 32.7282 0.600499 13.9817 -1.747 3.00212 +6869 4 16.3216 33.0562 0.17902 -12.1561 7.80428 -5.7129 +6870 6 1.309 17.4831 22.5447 23.3848 -11.3219 -15.6007 +6871 4 1.13597 16.5744 22.1718 3.15619 19.2398 8.80125 +6872 4 2.27868 17.6899 22.4311 -25.7511 -7.40397 3.71946 +6873 6 41.5587 6.87311 29.3039 4.08196 29.5448 1.53382 +6874 4 41.6919 5.95311 29.5356 2.80206 -5.98386 3.69024 +6875 4 41.9106 7.40602 30.0483 -3.99043 -10.4039 -5.51054 +6876 6 10.5167 10.7886 13.8618 17.7458 -17.1897 13.2051 +6877 4 10.6632 11.2096 13.003 1.79898 0.261401 -4.84225 +6878 4 11.2159 10.1 14.0373 -16.1376 17.4326 -7.31573 +6879 6 39.8332 15.4952 40.8309 13.3581 4.75609 3.89566 +6880 4 39.9392 16.0809 40.0548 0.3292 -3.56753 7.15077 +6881 4 40.6564 15.5643 41.3732 -15.0531 5.58747 -11.8726 +6882 6 26.5094 19.6057 40.5003 9.17758 -2.41024 9.24949 +6883 4 27.4312 19.885 40.5187 -1.32295 2.31326 -8.74715 +6884 4 26.4504 19.08 41.3172 -10.7617 -0.025449 -2.36491 +6885 6 54.0331 8.19348 13.7645 20.1265 23.4755 -3.20859 +6886 4 54.5379 7.42769 14.0195 10.1236 -9.46733 3.3174 +6887 4 53.1635 7.89609 13.5919 -33.2862 -9.18344 -4.84573 +6888 6 15.685 25.3343 10.6639 3.77823 -5.01457 0.699023 +6889 4 15.2925 25.3549 9.7704 -6.94194 -0.507815 8.78718 +6890 4 14.9859 25.2981 11.3464 3.26271 -0.250944 -15.837 +6891 6 18.6044 3.42728 21.9359 54.0117 -4.17358 13.1129 +6892 4 19.6007 3.50499 22.1915 -55.8621 -1.2706 -18.0159 +6893 4 18.5414 3.70523 21.0018 -0.6471 0.781857 10.4283 +6894 6 50.8906 20.6382 18.514 19.322 19.8933 14.7131 +6895 4 50.0771 21.0514 18.1693 2.40506 3.30677 2.13188 +6896 4 51.4314 21.2881 19.0676 -26.3068 -18.4046 -20.3942 +6897 6 53.3692 20.9044 31.2861 -2.87581 -0.0590227 -4.61483 +6898 4 53.3163 20.8663 32.2507 -1.10677 -1.05899 -2.14121 +6899 4 52.4655 20.8115 30.924 8.48272 0.484508 7.85381 +6900 6 52.8175 27.637 28.9992 -34.1073 -16.3293 -5.23745 +6901 4 52.1753 27.4604 29.7292 18.9476 13.4611 -8.14668 +6902 4 53.5412 28.184 29.256 17.7352 16.912 19.7012 +6903 6 33.3098 15.691 11.3293 10.3241 5.44869 29.2776 +6904 4 33.5439 15.9761 12.2647 -8.49351 -12.0766 -30.078 +6905 4 32.4682 16.1118 11.1139 -1.38634 1.49203 3.14806 +6906 6 20.3823 26.792 27.4754 10.6616 14.7237 17.2289 +6907 4 19.6846 27.4135 27.2507 -4.69437 -0.849554 -6.03625 +6908 4 20.895 27.2908 28.1563 -10.3656 -18.3754 -15.2612 +6909 6 8.54404 2.05454 14.1651 1.1449 13.7122 2.29602 +6910 4 8.12946 1.19872 14.2191 -6.02545 -13.9865 0.607463 +6911 4 8.06484 2.58201 14.8308 4.74922 -3.38849 -5.44478 +6912 6 40.1105 7.56396 40.6794 -0.469697 6.72942 -1.63666 +6913 4 39.7195 8.28533 41.2425 20.0171 -18.0739 -7.27063 +6914 4 40.8018 7.03949 41.1472 -13.6242 13.5344 3.71207 +6915 6 6.897 6.83213 10.7811 7.71606 15.0782 -3.77655 +6916 4 7.19774 7.75246 10.6132 -6.74961 -17.2243 4.00207 +6917 4 7.00156 6.6927 11.7358 -2.06706 0.697676 -4.80225 +6918 6 31.2469 6.57665 20.133 15.2512 -44.8317 5.05575 +6919 4 30.6435 5.99888 20.634 -3.65198 3.16249 1.16613 +6920 4 30.7682 7.35458 19.9689 -22.0921 35.6742 -6.0398 +6921 6 54.5384 21.0446 27.3066 23.2273 -48.3206 40.5729 +6922 4 0.0992734 20.2122 27.4067 -21.2046 24.987 7.15799 +6923 4 54.6588 21.2398 26.4073 -2.82622 20.9035 -45.5707 +6924 6 4.74298 23.1434 16.2203 -30.2995 19.4891 -12.6787 +6925 4 4.36556 24.0555 16.215 7.46998 -18.526 0.357752 +6926 4 5.49124 23.2367 16.7883 23.1348 -5.45784 14.6166 +6927 6 25.5466 11.0338 14.8277 10.3359 0.700294 4.3384 +6928 4 26.1246 10.3443 15.2243 -8.70528 11.4294 -11.7317 +6929 4 25.9183 11.8873 15.0941 -0.865353 -5.34287 -3.41216 +6930 6 41.1962 41.784 29.9422 -30.017 -5.50367 -10.8152 +6931 4 40.9141 40.905 29.5845 10.5201 22.1914 8.67773 +6932 4 40.3904 0.453034 29.9085 19.4524 -11.6054 2.3136 +6933 6 52.2783 15.2862 41.6211 7.07203 -4.19206 -10.8941 +6934 4 51.9431 15.9476 0.307056 -1.67854 11.1856 8.97788 +6935 4 51.5699 14.6487 41.5543 -8.05659 -11.9472 -4.98288 +6936 6 37.758 21.7866 37.8526 10.4754 12.291 4.40187 +6937 4 37.8833 20.8525 37.7239 2.64231 -18.5298 -3.43162 +6938 4 38.1062 21.9123 38.7409 -0.189838 4.59809 2.45253 +6939 6 23.846 9.72877 27.5599 -20.0483 -53.0743 -18.3837 +6940 4 23.7508 8.9538 26.878 9.78252 41.145 35.6193 +6941 4 23.2758 9.50619 28.3397 9.82275 7.24107 -18.911 +6942 6 43.0179 28.0371 32.8168 -8.27592 12.0689 -0.875134 +6943 4 42.8326 27.1827 33.2413 14.9994 1.75302 -2.99965 +6944 4 43.9358 28.1723 32.5349 -8.32605 -13.2452 6.20231 +6945 6 34.1493 21.223 11.895 -6.4617 -26.4803 6.62596 +6946 4 33.7114 20.3967 12.2433 5.74917 23.5867 -12.2191 +6947 4 33.6625 21.5015 11.0997 -1.34318 -2.64619 5.02085 +6948 6 10.5048 31.8203 10.0934 3.12763 27.8567 -5.97475 +6949 4 10.8893 32.6663 10.3856 -2.25958 -16.5293 2.97323 +6950 4 10.042 32.0955 9.27903 1.62317 -10.8132 6.61598 +6951 6 35.8582 37.1311 22.1219 17.442 6.8165 -15.3109 +6952 4 36.7754 37.4644 22.0121 -13.2022 -8.29883 -6.66499 +6953 4 35.6795 37.2674 23.0383 -11.5038 0.0185045 25.2366 +6954 6 27.2889 4.59659 27.4585 -59.4895 -12.2555 32.2126 +6955 4 27.8503 4.63259 28.2407 7.94553 1.46958 -1.61102 +6956 4 26.3513 4.38137 27.8533 49.6255 8.2673 -26.6042 +6957 6 39.0071 22.2889 10.6559 -18.7539 6.55471 8.53947 +6958 4 39.6145 22.0219 9.97399 11.0637 -4.63202 -10.5583 +6959 4 38.132 22.2267 10.2407 1.98377 -6.13574 3.6668 +6960 6 30.7475 39.195 10.9378 13.4076 -25.4475 -2.13886 +6961 4 31.7135 39.1987 10.9202 1.84768 25.2682 1.10777 +6962 4 30.6542 38.2342 10.8274 -15.9936 9.0572 -1.5893 +6963 6 44.6038 26.9469 2.19596 -3.02312 -2.7981 0.496435 +6964 4 44.789 26.0668 2.58199 4.34993 15.1048 -14.5643 +6965 4 45.3477 27.2287 1.63769 1.54159 -5.20589 8.29494 +6966 6 23.7761 14.5574 26.4892 -1.60295 28.5342 -20.4107 +6967 4 23.6176 15.1119 25.659 4.49284 -25.3407 28.839 +6968 4 23.2395 13.7622 26.4238 -2.18231 -2.53609 -2.40557 +6969 6 38.3444 13.3746 39.6516 36.4054 -1.80378 3.51049 +6970 4 39.1202 13.8805 40.0461 -33.1028 -11.4882 -12.1373 +6971 4 37.5326 13.855 39.8351 -2.35218 5.60767 6.28087 +6972 6 17.8972 17.2344 29.4073 9.50877 -9.96512 10.1834 +6973 4 17.6974 16.8197 28.5593 -3.90288 0.722299 -3.3346 +6974 4 17.259 17.9348 29.5179 -13.7448 8.39178 0.729907 +6975 6 17.4263 29.84 9.91085 4.63967 13.4244 18.4952 +6976 4 16.5241 29.7155 9.63978 -6.68442 -7.79832 -10.641 +6977 4 18.0121 29.6473 9.18714 6.17675 -5.88453 -9.84082 +6978 6 35.6257 6.05657 19.614 -2.53427 -7.67526 1.74575 +6979 4 35.1442 5.56448 18.9178 7.07991 15.7277 0.668344 +6980 4 35.8526 6.94177 19.2847 -2.44106 -6.98166 -5.33042 +6981 6 18.6731 22.2952 17.5195 -8.35574 4.99894 -0.254983 +6982 4 17.7298 22.4259 17.6349 -7.1371 0.699885 10.6378 +6983 4 18.7532 22.3981 16.578 9.97204 2.32932 -16.3296 +6984 6 20.0126 3.82895 32.2846 -5.38506 7.6032 10.998 +6985 4 19.7316 4.05659 31.3951 3.95105 0.959407 -6.40709 +6986 4 20.9087 3.45699 32.2166 -3.62371 1.18893 -2.87546 +6987 6 5.48106 6.97474 8.11911 -13.3431 -28.5569 -4.23146 +6988 4 5.76723 7.87539 8.05126 9.5873 19.9723 5.64469 +6989 4 5.84003 6.56862 8.91875 4.365 4.20298 7.41399 +6990 6 44.2055 20.527 25.594 -36.5422 -32.7496 -22.1294 +6991 4 44.4952 21.1964 26.2048 27.2712 12.1663 0.509182 +6992 4 44.8136 20.1687 24.9192 13.264 16.717 13.5958 +6993 6 43.9676 36.9898 17.8707 9.43563 13.9581 11.3899 +6994 4 44.6425 37.4866 17.3506 -13.9886 -14.2814 1.04264 +6995 4 43.5166 36.316 17.3518 1.57776 -4.71986 -9.07493 +6996 6 34.624 10.1249 16.2553 -3.80507 -0.870494 -23.8528 +6997 4 34.4029 10.0232 15.2766 7.60873 7.05542 33.3523 +6998 4 34.6485 11.0843 16.4397 0.136369 -4.79707 -6.11079 +6999 6 23.6588 3.43472 1.31587 2.0947 2.20184 -10.1691 +7000 4 23.5283 2.45383 1.23665 3.68597 29.2686 -10.0862 +7001 4 23.7829 3.95594 0.465507 -5.48879 -27.0668 21.3429 +7002 6 33.408 38.9514 5.0951 12.9752 29.4037 8.61745 +7003 4 33.0296 38.079 4.95882 -18.4714 -2.71742 3.9597 +7004 4 32.7559 39.6696 5.33685 4.56028 -29.4715 -9.24259 +7005 6 22.5612 32.5054 35.7914 -7.59797 17.3543 -6.08959 +7006 4 23.434 32.1498 35.9581 8.59623 -0.183209 1.98348 +7007 4 22.6598 33.4814 35.6698 2.01652 -18.126 2.22848 +7008 6 32.4197 37.2669 13.8205 20.7322 22.1346 -9.91782 +7009 4 31.6112 36.8955 13.5272 -29.3682 -10.7083 -8.61391 +7010 4 32.7793 36.5983 14.3861 8.71878 -17.2052 10.8721 +7011 6 52.6061 12.7509 39.5955 -8.08982 -5.36768 -0.728302 +7012 4 53.2357 13.3696 39.2333 6.80499 9.05338 -6.44134 +7013 4 53.0752 12.2813 40.2869 4.34006 -2.9945 3.85342 +7014 6 28.8406 14.5639 1.22393 13.2702 13.2594 -7.07732 +7015 4 28.2547 13.832 1.29641 -8.98786 -23.9917 -3.18497 +7016 4 28.3081 15.2705 1.57856 0.691728 8.20301 3.76967 +7017 6 1.46371 32.4171 23.3808 -12.1734 -25.5645 13.9938 +7018 4 1.52421 31.5049 23.0145 7.51613 19.861 -1.66683 +7019 4 1.90409 33.05 22.8306 10.4998 5.06095 -20.3958 +7020 6 54.3326 23.3294 28.9734 2.61182 15.3833 -1.51239 +7021 4 54.2696 22.9227 29.8387 -0.130455 -4.55084 5.05008 +7022 4 54.4476 22.6226 28.3359 -0.0534198 -9.82677 -0.516761 +7023 6 14.3165 12.143 35.6759 -19.2415 -8.81627 -0.503167 +7024 4 14.3877 12.7977 36.3527 0.233596 18.6669 11.2481 +7025 4 15.2077 11.8775 35.5438 25.0768 -7.98239 -7.51161 +7026 6 18.9926 6.51479 41.2701 -28.9824 -29.6237 1.81046 +7027 4 18.266 5.84223 41.3522 13.7729 17.3268 -5.20094 +7028 4 19.3309 6.57432 0.258232 8.64619 7.1183 4.95474 +7029 6 5.3156 17.8978 20.3375 -21.1545 16.5991 3.60383 +7030 4 4.72623 18.3448 19.6879 4.29754 -5.05212 8.41069 +7031 4 4.82948 17.9368 21.1935 9.1049 1.98802 -15.8618 +7032 6 24.7216 34.9676 30.1666 -3.07326 -14.2394 -14.8574 +7033 4 24.8542 35.9126 30.1802 4.14387 12.0412 4.3338 +7034 4 24.7023 34.7085 29.2239 -0.0690866 8.67132 12.606 +7035 6 31.8759 4.61762 18.1838 16.2734 -6.94643 -1.61547 +7036 4 31.7767 5.32612 18.8146 -0.693712 9.66586 8.6442 +7037 4 30.9961 4.53608 17.8264 -12.7431 -2.99311 -6.3499 +7038 6 8.70679 17.4876 5.93376 -7.2594 15.0659 3.57914 +7039 4 7.94553 18.1226 5.84491 19.4684 -9.25267 2.2845 +7040 4 9.55198 17.9922 5.98984 -15.4384 -2.82622 -0.0668602 +7041 6 29.8338 10.9771 14.4736 2.85583 -20.8689 4.17621 +7042 4 29.3487 11.4359 13.7779 -2.35633 12.0716 2.99849 +7043 4 29.9333 11.5067 15.2792 -5.11986 9.15119 -1.36774 +7044 6 48.7176 10.2992 32.5766 37.752 -4.2965 -7.5649 +7045 4 48.6861 9.98692 33.5109 4.36425 8.41374 -15.5521 +7046 4 49.6689 10.1741 32.2115 -43.6207 3.75412 17.6406 +7047 6 8.33261 15.6868 37.8739 25.2856 -16.7599 -34.932 +7048 4 8.10095 16.0156 38.719 -17.2941 17.7495 29.2541 +7049 4 7.84865 16.1686 37.1872 -4.77393 6.83012 10.4818 +7050 6 50.4 3.07893 17.326 6.75193 2.54677 -10.5223 +7051 4 49.8476 3.08454 16.5614 0.0537611 0.514048 -24.7797 +7052 4 49.7563 3.22783 17.9993 -5.52918 6.4504 35.6689 +7053 6 14.6925 38.3995 10.8943 -10.4545 -11.2686 -1.07851 +7054 4 14.3539 38.6226 11.7634 0.533319 14.8424 10.3104 +7055 4 14.2274 37.5681 10.7419 5.82896 -0.087222 -8.72758 +7056 6 34.1157 6.37736 10.827 20.4112 17.5403 9.63945 +7057 4 34.1356 7.15575 10.2337 -4.79421 -13.4894 2.09643 +7058 4 34.9392 6.47467 11.3721 -17.4677 -2.57189 -8.67394 +7059 6 7.16428 37.5549 17.6272 35.8206 -6.94283 1.42456 +7060 4 8.17672 37.4379 17.5039 -45.4701 3.04153 9.54579 +7061 4 6.9329 37.0909 18.4673 4.48983 7.2965 -12.9876 +7062 6 51.5173 11.3068 16.7982 -29.6345 12.4732 -19.9425 +7063 4 52.2329 10.8476 17.1999 24.0623 -16.8016 7.00331 +7064 4 51.4947 11.1437 15.8343 5.46468 -1.37513 9.57578 +7065 6 15.6604 8.64432 3.1895 3.55656 -13.2601 -18.336 +7066 4 15.3831 9.26805 3.84437 -11.3932 20.6181 15.5674 +7067 4 16.2117 8.03967 3.68493 6.317 -8.49687 -0.892024 +7068 6 5.4241 21.4549 11.925 7.11554 10.6798 -7.02681 +7069 4 5.33432 22.3429 11.4717 -4.65036 -17.889 17.4658 +7070 4 4.77116 21.2815 12.6313 -0.367847 15.68 -7.67111 +7071 6 50.1893 24.0442 37.9781 -13.1484 0.855785 -17.0816 +7072 4 49.5179 24.1845 37.2801 8.13829 0.111989 16.6227 +7073 4 50.739 23.3224 37.6715 2.2014 -1.01472 3.1635 +7074 6 39.7382 11.2507 31.6977 23.6406 7.23187 -3.58891 +7075 4 40.4046 11.8538 31.2923 -18.8268 -10.2166 5.80002 +7076 4 38.8713 11.6238 31.5229 -1.54541 8.70996 -4.13134 +7077 6 26.6923 10.8294 20.5841 1.50171 17.3672 -0.163562 +7078 4 26.3063 11.3901 21.299 5.00814 -17.7696 -11.6362 +7079 4 26.5519 9.91114 20.8376 -1.99146 -0.979444 5.82041 +7080 6 12.5744 17.5779 18.1705 9.62673 -31.396 -11.9521 +7081 4 12.2909 16.663 17.987 19.11 1.74385 -8.92353 +7082 4 11.8345 17.8227 18.6757 -30.0259 29.7826 25.4081 +7083 6 47.7778 31.6094 17.3292 -7.10666 -17.038 -8.06235 +7084 4 48.347 31.2547 18.014 2.28217 1.30733 4.94459 +7085 4 47.3418 30.8212 16.9416 1.10301 17.3121 -1.07651 +7086 6 1.06524 3.39018 18.5298 -14.3894 10.3619 10.5476 +7087 4 1.40487 3.81402 19.3241 14.4239 4.64695 -0.395869 +7088 4 0.13491 3.28998 18.7837 -2.56119 -4.67364 -10.5163 +7089 6 26.5953 20.387 15.3121 4.86749 -24.5982 -5.101 +7090 4 27.0693 19.5476 15.0746 -6.18915 17.8108 6.48343 +7091 4 25.6882 20.059 15.4501 7.15985 4.40883 -1.86988 +7092 6 42.0068 3.03472 36.7639 -8.02624 -14.3838 3.82934 +7093 4 41.5138 2.21919 36.6422 -1.8797 -9.24856 -19.1073 +7094 4 41.9017 3.12445 37.6992 6.42334 14.3979 20.8626 +7095 6 39.3283 22.4329 33.1866 16.7976 22.9312 16.1168 +7096 4 39.617 22.6043 34.1233 -9.1007 -15.4059 -24.4851 +7097 4 39.2996 23.351 32.8579 -1.9326 -13.3537 -7.72798 +7098 6 18.5014 34.9723 11.9503 -40.872 8.93582 -22.0032 +7099 4 19.313 34.895 12.3871 37.9781 -3.12322 33.9295 +7100 4 17.8134 35.1232 12.6133 -0.0311416 1.40314 8.7121 +7101 6 22.862 14.1089 0.203393 17.2545 -2.37957 19.5806 +7102 4 23.1276 14.8054 41.5255 0.219481 9.03583 -13.3452 +7103 4 23.4003 14.3117 0.999915 -8.23864 -6.67581 -7.59618 +7104 6 30.9898 16.6325 33.7811 -26.24 4.82889 -18.7278 +7105 4 30.4991 16.9295 32.9906 -1.06726 -7.21679 15.5744 +7106 4 31.8724 16.8786 33.545 20.2345 1.84197 6.64809 +7107 6 28.4142 35.5086 5.55132 5.25795 11.5001 -0.86936 +7108 4 29.133 34.8901 5.6729 7.87573 -11.0207 0.32142 +7109 4 28.8444 36.3678 5.44284 -5.96253 -1.38672 0.306744 +7110 6 2.06178 31.4487 10.6522 7.7724 2.5252 5.43788 +7111 4 2.46787 32.1741 10.1582 1.48866 -1.05725 0.00513454 +7112 4 1.12423 31.5492 10.4902 -10.7705 -1.69396 -4.48797 +7113 6 5.96168 9.75465 21.3469 -3.89643 8.81348 -50.5901 +7114 4 6.28958 10.5041 20.7544 -9.04712 -29.7196 22.9081 +7115 4 5.37557 9.21645 20.7377 15.5825 17.9805 22.1648 +7116 6 24.7784 26.6095 2.66066 11.1746 -2.24162 5.28408 +7117 4 23.9956 26.7754 2.10108 -2.29597 -10.0774 9.56872 +7118 4 24.6953 25.8682 3.30791 -10.2989 11.7132 -14.8816 +7119 6 45.7373 4.24983 18.6143 27.3178 -0.763462 -4.2154 +7120 4 46.5067 4.85242 18.4954 -19.0177 -2.03966 3.70694 +7121 4 46.1538 3.38182 18.4484 -14.6954 3.88493 3.6473 +7122 6 4.46307 0.776675 15.9004 -0.0751459 19.7124 -7.24544 +7123 4 4.28648 41.7452 15.8506 7.90268 -11.6504 4.49907 +7124 4 5.34722 0.941656 16.2766 -7.84 -9.44871 -1.18019 +7125 6 2.43543 19.4835 25.3975 -8.02289 7.34849 22.5637 +7126 4 1.8039 19.0427 26.0095 9.34608 -2.48106 -16.7091 +7127 4 2.63666 18.9452 24.6346 -2.8512 -10.1259 -3.82486 +7128 6 40.5893 8.48301 5.11314 -1.35782 -12.8068 -2.32465 +7129 4 40.7524 9.27543 5.61119 -3.30667 17.7402 10.4879 +7130 4 41.4486 8.05286 5.16027 3.34022 -8.8045 -8.92488 +7131 6 49.3107 22.3512 41.5276 -10.6582 56.3201 6.76971 +7132 4 48.577 22.7852 41.0387 15.264 -8.60422 5.01334 +7133 4 49.2575 21.458 41.2835 -0.448838 -46.7272 -11.6484 +7134 6 0.358901 40.9209 20.5803 -19.8443 -5.20423 -21.0143 +7135 4 0.209912 39.9476 20.5616 0.00996972 10.506 -0.843682 +7136 4 54.6254 41.351 20.0384 15.1519 -13.0167 14.2251 +7137 6 34.868 15.3449 38.0159 -4.77394 11.9701 -21.6163 +7138 4 34.21 16.0699 37.905 14.1938 -11.5268 -7.28032 +7139 4 35.478 15.4115 37.2329 -18.0572 6.07255 16.3223 +7140 6 7.76403 26.0071 29.8556 5.34791 -0.957035 4.21351 +7141 4 8.62364 26.4528 30.0224 -8.82329 -12.5157 -0.945539 +7142 4 7.90301 25.0604 30.0866 1.23738 19.4493 -2.25897 +7143 6 40.714 22.798 20.4449 30.2403 28.6605 -20.1452 +7144 4 41.3584 23.4838 20.081 -22.4198 -29.1089 11.875 +7145 4 40.2102 23.3285 21.0558 -12.075 4.18803 12.4472 +7146 6 37.6868 25.6422 36.0641 6.66209 -5.59755 13.6904 +7147 4 38.2808 24.8923 36.0269 4.65063 -3.44496 7.57849 +7148 4 37.3429 25.6351 35.1859 -16.0941 8.70932 -25.1352 +7149 6 5.45062 23.9828 10.2587 5.16865 5.9624 5.01697 +7150 4 5.97911 23.8188 9.45867 -6.21725 4.51436 8.29683 +7151 4 5.82702 24.8173 10.6422 -10.2102 -24.7042 -13.9856 +7152 6 48.3972 21.0585 38.1887 36.079 14.8531 -15.9941 +7153 4 48.9083 20.6932 38.9203 -9.15007 -3.24726 4.47194 +7154 4 49.1186 21.3212 37.5505 -33.8036 -6.43701 14.9947 +7155 6 15.2894 25.0118 3.53737 -15.5341 -16.8072 10.9824 +7156 4 15.3523 24.0463 3.54635 7.80908 -0.218079 -10.1213 +7157 4 14.6524 25.152 4.25109 -0.971191 12.1275 -1.41446 +7158 6 46.3973 40.2818 20.0864 -5.10979 -28.8528 0.810189 +7159 4 46.7099 39.3289 20.1836 -4.69047 35.7762 -3.66479 +7160 4 47.1343 40.8792 20.2285 11.4236 3.93541 -0.385178 +7161 6 34.6613 36.4755 0.335066 -24.7851 30.4749 -21.6933 +7162 4 34.8743 36.0541 1.15687 -4.43901 -4.57192 24.0914 +7163 4 33.7851 36.9546 0.454416 30.1492 -20.7825 2.99091 +7164 6 52.5881 7.99834 30.4195 9.51271 -12.4348 0.483116 +7165 4 52.1042 8.76616 30.7719 -8.49213 -7.21741 -10.9068 +7166 4 52.0722 7.46347 29.7764 0.520668 12.6171 10.1624 +7167 6 32.0714 3.86484 29.4697 -9.7538 -17.9077 -31.6249 +7168 4 31.6702 2.97314 29.6052 7.93851 20.6113 2.31556 +7169 4 32.0839 3.94733 28.4741 0.539668 -3.17995 32.4864 +7170 6 20.3786 17.8365 28.6466 -12.59 16.0252 -12.2548 +7171 4 19.5397 17.5939 29.0718 10.0495 1.57584 1.91854 +7172 4 20.0545 18.3008 27.843 10.529 -6.18443 10.1885 +7173 6 30.4085 41.1704 41.0135 6.18506 -3.22706 -14.2809 +7174 4 30.53 40.7341 40.1581 -10.3332 2.11637 -0.589059 +7175 4 31.2241 40.9477 41.4498 10.7912 2.88832 12.9661 +7176 6 35.4567 32.8541 27.9296 20.1033 20.3116 -25.2142 +7177 4 35.1103 33.2872 28.7174 -1.27312 4.66796 4.01126 +7178 4 35.9087 33.5476 27.342 -15.0191 -24.2746 21.4934 +7179 6 14.3794 6.67806 12.7301 -1.9413 28.2373 -4.00169 +7180 4 15.2373 6.26429 12.8613 2.01848 -2.11516 -0.858514 +7181 4 14.5332 7.65903 12.7289 -3.54891 -27.4927 -2.87641 +7182 6 41.884 41.5441 20.3292 17.5267 3.97767 -7.39307 +7183 4 42.6467 41.3531 19.7473 -6.80228 5.43899 6.41045 +7184 4 41.2989 40.8038 20.1922 -8.54368 -4.96293 -3.75352 +7185 6 46.4016 22.5784 8.86191 7.75251 -10.6521 7.11129 +7186 4 45.8476 21.8716 8.52158 -12.3576 2.35246 -8.51817 +7187 4 47.0146 22.0703 9.39636 1.75986 6.35736 5.22437 +7188 6 17.4049 20.6472 13.8946 9.03444 14.2526 1.49725 +7189 4 17.6929 21.5842 14.0543 -8.3446 -25.4959 -7.46489 +7190 4 17.3265 20.4984 12.9333 2.034 6.01629 5.63707 +7191 6 8.18883 9.49722 13.352 -36.2403 7.79383 -0.838203 +7192 4 7.38606 10.0563 13.5919 32.9103 -12.129 -3.09847 +7193 4 9.02271 9.90793 13.6245 -5.40631 9.4956 5.41337 +7194 6 7.5857 14.8045 29.5864 0.660595 8.18183 -2.22865 +7195 4 7.08502 14.4366 30.3218 -1.52277 2.83209 3.37304 +7196 4 7.02502 15.474 29.1565 2.15616 -5.78955 1.98978 +7197 6 29.5787 39.2199 22.642 -23.9064 2.77655 4.40715 +7198 4 29.7923 38.7231 23.4359 12.3113 -5.95711 5.92816 +7199 4 30.3289 39.2945 22.0576 16.6647 -3.01011 -3.30282 +7200 6 19.7261 28.8048 8.43629 7.07867 10.1416 -1.30332 +7201 4 19.5094 27.8711 8.56662 5.24428 2.50367 -2.7317 +7202 4 20.6808 28.8901 8.64157 -12.3267 -4.04756 -0.658665 +7203 6 20.0918 21.6433 25.9098 -22.8378 18.9737 -2.62589 +7204 4 20.6828 21.9331 26.6394 -14.5657 0.991195 -11.6344 +7205 4 19.2872 22.2354 25.9429 24.6623 -16.2361 5.64257 +7206 6 12.7798 16.1171 22.7918 2.83481 -1.66518 -8.4999 +7207 4 12.1052 16.761 22.5802 -5.26913 11.1277 0.000470885 +7208 4 12.4145 15.3113 22.3987 5.67676 1.62415 3.74644 +7209 6 7.09341 27.2127 17.9852 -17.6727 17.6357 -2.43489 +7210 4 7.71878 26.5086 17.8851 15.5779 -18.3258 -2.50971 +7211 4 7.24623 27.7931 17.2297 2.82114 0.873921 -0.89624 +7212 6 32.4121 8.69011 34.8574 -11.3856 31.068 25.9423 +7213 4 32.686 9.10208 35.716 -2.62469 -14.8204 -24.695 +7214 4 31.4981 9.04705 34.7249 20.8054 -13.4625 -4.53694 +7215 6 50.3489 28.2274 17.5408 2.96892 -19.9668 3.87059 +7216 4 50.2931 27.3328 17.9381 -3.71715 13.2344 -0.552608 +7217 4 51.012 28.0828 16.8476 -2.81747 8.99858 -3.49204 +7218 6 15.6752 32.1523 25.7996 -24.1097 -1.02752 -8.0065 +7219 4 16.4469 32.5721 26.1513 19.1192 7.47953 7.03048 +7220 4 15.1241 32.8942 25.4834 5.39501 -5.59697 3.80799 +7221 6 41.2942 22.0009 29.6469 23.8016 -11.3242 12.4312 +7222 4 40.6197 22.5451 29.2897 -20.6362 19.5621 -14.8771 +7223 4 40.8321 21.2604 30.0334 -1.27155 -6.80964 4.85239 +7224 6 24.5512 12.7478 8.87624 0.539479 -2.56763 -16.1827 +7225 4 24.2317 13.5544 9.29419 1.48927 0.294937 0.678301 +7226 4 24.2485 12.8104 7.9491 4.47413 -5.17195 11.4459 +7227 6 47.3043 20.1171 10.4067 20.0451 13.2477 8.4905 +7228 4 48.2327 20.3756 10.3708 -0.951507 4.56311 9.88278 +7229 4 47.2371 19.5522 9.64912 -14.6685 -17.4861 -17.2657 +7230 6 17.6686 14.2187 29.9453 7.31834 -6.07886 -8.28437 +7231 4 16.8567 14.6777 30.1627 -12.3548 11.6861 -0.426412 +7232 4 18.1621 14.7508 29.3045 -6.68566 0.573373 4.02912 +7233 6 21.3468 34.5864 28.5404 1.3464 21.7174 -7.002 +7234 4 21.5866 35.4807 28.2285 -6.04705 -7.23946 1.73439 +7235 4 21.8012 34.5133 29.372 6.90897 -8.71765 12.9147 +7236 6 35.0919 4.05058 4.01374 -15.5825 9.30565 11.5721 +7237 4 34.2387 3.74233 4.43927 22.4566 16.9059 -11.4445 +7238 4 35.1406 5.04582 3.93988 -11.3656 -25.7387 7.52347 +7239 6 29.9083 8.58745 22.5962 -15.8002 1.46007 -28.7439 +7240 4 29.4293 8.33193 21.7391 23.5037 3.33824 36.5279 +7241 4 30.4512 7.83881 22.8901 -6.5033 3.48596 -7.29863 +7242 6 9.80484 32.9578 15.933 -3.40746 -8.77641 -12.0557 +7243 4 9.78146 31.9986 16.1651 13.0086 23.7442 4.23133 +7244 4 10.4547 33.4728 16.4465 2.19651 -19.1398 5.78046 +7245 6 24.9207 14.2283 32.5839 15.8568 -2.03515 22.8032 +7246 4 25.4679 14.491 33.3602 -10.7028 -6.65113 -14.6818 +7247 4 24.5651 15.0495 32.2637 -5.99659 7.67207 -7.30645 +7248 6 49.6599 21.9679 26.2292 42.3899 27.0609 3.31449 +7249 4 50.4576 21.5325 26.6526 -24.3124 13.7703 -9.69582 +7250 4 49.9726 22.89 25.9802 -16.6307 -33.6109 8.97028 +7251 6 39.2146 29.6271 28.776 1.2649 -6.72815 -4.66326 +7252 4 39.3113 29.0399 29.5368 -1.10705 1.67847 4.24024 +7253 4 39.5646 29.0864 28.052 -0.275695 2.9096 0.748968 +7254 6 50.692 34.7829 39.7485 29.9384 -8.83369 -9.14761 +7255 4 51.6379 34.6172 39.5245 -10.9597 10.0847 13.0799 +7256 4 50.284 34.1892 39.1195 -14.598 -6.88033 -5.74908 +7257 6 29.205 20.8761 19.5187 12.6622 -8.88768 18.517 +7258 4 30.1458 21.1462 19.5468 -10.0278 2.51211 -7.13483 +7259 4 28.7621 21.2804 18.7794 -5.02457 12.868 -15.5739 +7260 6 45.8413 1.41619 21.3894 -25.1775 13.0352 -19.0829 +7261 4 45.002 1.0285 21.6935 10.996 -3.183 3.42833 +7262 4 46.5512 0.981978 21.8333 16.3199 -17.0363 14.4799 +7263 6 26.0942 5.84138 12.9755 -8.81801 -1.79204 -2.94978 +7264 4 26.5644 5.00851 12.8396 1.48472 -6.22175 2.21387 +7265 4 25.1658 5.65249 12.7519 4.56693 -2.33816 -1.27821 +7266 6 9.00853 19.0479 23.7214 20.279 18.3012 -13.9253 +7267 4 8.07192 18.8993 23.8406 -12.3386 2.44029 -0.494901 +7268 4 9.09287 19.8709 23.17 -6.05991 -16.4473 11.9144 +7269 6 47.699 14.1778 40.0244 8.37408 5.46764 -8.11648 +7270 4 48.526 14.369 39.5365 -13.6583 -0.0280305 9.55934 +7271 4 47.2742 15.0291 40.2237 1.48315 -6.20176 -4.56159 +7272 6 47.9891 19.7944 0.501942 -52.5058 -34.5194 5.9677 +7273 4 48.5389 19.8149 1.25758 31.4646 9.24384 22.8657 +7274 4 47.3233 19.1101 0.79406 16.1078 24.936 -21.6052 +7275 6 27.1644 39.5895 31.4222 -35.4984 -42.2857 -13.2745 +7276 4 26.8828 40.2644 32.0188 2.45392 19.408 13.0965 +7277 4 26.334 39.0158 31.3353 32.2444 14.87 -2.1562 +7278 6 20.718 15.281 27.2921 -20.5288 29.0824 -25.1338 +7279 4 19.7916 15.5288 27.1303 0.0426049 -12.6319 11.5337 +7280 4 21.1251 16.0883 26.9354 13.4588 -8.377 2.43969 +7281 6 53.2931 3.12982 19.6939 21.059 35.3193 6.93312 +7282 4 52.5111 3.68486 19.642 -0.600406 9.66435 -1.15328 +7283 4 52.9649 2.26115 19.6482 -6.97037 -43.0252 -2.92507 +7284 6 40.7577 33.3874 24.037 12.7176 -1.25655 15.6318 +7285 4 41.575 33.1492 24.5319 -10.6485 3.51614 -11.0419 +7286 4 40.1417 32.64 24.1417 6.01104 2.31945 0.566227 +7287 6 50.2034 37.8915 21.3784 34.5696 42.4783 -9.46203 +7288 4 50.977 37.3667 21.5595 20.6596 -6.9612 4.63629 +7289 4 49.5128 37.3071 21.51 -51.1752 -39.6198 7.18684 +7290 6 41.3315 2.34663 21.9881 -5.34027 -0.787955 22.4754 +7291 4 41.3778 2.5308 21.0564 -4.51788 5.59338 -11.8441 +7292 4 40.4369 2.61524 22.307 16.348 -5.18373 -12.1741 +7293 6 3.68887 21.2797 14.3363 -13.7249 24.7693 -29.296 +7294 4 4.1389 21.9084 14.895 6.09004 12.6164 9.74183 +7295 4 3.85532 20.4521 14.7268 10.1618 -35.5887 19.7816 +7296 6 34.2749 11.1621 36.6211 6.86722 -26.3475 -8.98455 +7297 4 34.1457 10.3739 37.2084 1.76529 18.7936 -6.49638 +7298 4 34.0208 11.9523 37.0887 -10.0392 4.20616 19.2695 +7299 6 24.047 21.9251 23.4534 9.96695 -9.01801 9.45846 +7300 4 24.1056 21.4984 22.592 0.489969 -1.19981 -5.95122 +7301 4 24.6049 21.3417 24.0221 -10.3198 12.7259 -7.25629 +7302 6 18.8859 0.355593 4.41703 6.91373 -0.488994 13.8226 +7303 4 18.8848 41.346 4.15992 -3.4937 -3.21088 -8.69706 +7304 4 19.4141 0.350836 5.23016 -4.89519 7.76131 -7.17368 +7305 6 1.61894 7.82812 17.7388 11.0013 -2.20401 0.0755565 +7306 4 1.69825 6.91132 17.4299 0.598176 5.44338 0.144381 +7307 4 0.751076 7.92867 18.1276 -6.88769 -1.80246 0.772288 +7308 6 9.88357 31.5477 26.4865 20.7425 -47.9078 -25.9665 +7309 4 9.77347 30.8406 25.7562 4.13802 32.2768 29.9214 +7310 4 9.16637 32.1481 26.416 -28.5637 22.827 -5.6847 +7311 6 46.9801 33.0031 20.3665 8.92807 -2.6835 25.0439 +7312 4 47.1906 32.5959 21.2783 -12.5238 7.50902 -41.0074 +7313 4 46.473 32.3868 19.8049 3.08737 -2.68707 12.6131 +7314 6 49.5381 29.29 21.3848 5.35466 4.48298 6.61079 +7315 4 50.3596 28.8237 21.4263 11.6576 -22.6485 -14.6982 +7316 4 49.6544 29.7814 22.1942 -19.8316 15.0268 8.13943 +7317 6 13.5135 31.8933 19.1567 20.4477 19.0535 18.7588 +7318 4 12.9544 32.0303 19.9484 11.7182 -3.51681 -10.2564 +7319 4 14.3688 32.3555 19.4049 -26.6747 -15.4769 -10.5401 +7320 6 46.6242 34.0973 16.9259 3.25439 -22.1556 18.333 +7321 4 46.8986 34.1178 16.0034 3.18051 -0.659651 -5.23437 +7322 4 46.9878 33.2447 17.2966 -6.98741 23.2488 -14.973 +7323 6 19.7685 39.5238 2.42723 -1.93992 9.56528 -9.07466 +7324 4 20.504 40.1421 2.55739 -2.20075 -2.41675 -0.557551 +7325 4 19.2228 39.9982 1.75695 7.86662 -14.3322 13.7479 +7326 6 16.5372 9.39399 28.3106 5.81076 4.55242 0.698497 +7327 4 16.5228 10.3583 28.3138 -6.10914 3.2393 2.1867 +7328 4 17.4567 9.2086 28.1181 8.68803 -11.6531 -1.09187 +7329 6 3.04764 33.3834 8.9498 9.15555 8.47462 14.2626 +7330 4 2.34782 34.0603 8.86882 1.18173 -6.7492 -12.1187 +7331 4 3.16543 32.8691 8.13996 -9.91006 6.39371 -6.60301 +7332 6 49.6799 28.314 0.198287 -24.1009 9.02482 3.02524 +7333 4 50.5864 28.3416 41.8577 25.8797 -1.22492 -6.2647 +7334 4 49.539 27.5375 0.746128 -0.431885 -1.84115 5.43874 +7335 6 1.41501 6.84656 30.491 -4.80497 13.9866 22.936 +7336 4 1.80101 7.66454 30.873 3.64878 -10.2221 -13.1962 +7337 4 0.770406 6.61566 31.1883 9.6026 -0.286793 -13.8716 +7338 6 19.7721 9.41455 33.714 -8.86768 10.4812 -29.5452 +7339 4 19.9336 8.45599 33.7164 -2.74186 3.51224 -8.50186 +7340 4 19.4649 9.70036 32.7878 8.54711 -12.9815 34.2723 +7341 6 26.1689 11.9219 3.60877 17.3014 14.1658 -18.8808 +7342 4 25.6285 12.278 4.29668 -11.0155 5.7348 17.6305 +7343 4 26.0891 10.974 3.64129 -4.70103 -13.8965 4.54114 +7344 6 33.2526 2.15457 18.2061 -11.4346 36.8522 -3.73875 +7345 4 32.7853 2.99777 18.4754 10.6797 -23.9754 -11.6278 +7346 4 32.6748 1.45157 18.4903 -6.58847 -5.37306 4.71859 +7347 6 1.56641 29.1164 15.6218 -13.5802 38.9916 52.9136 +7348 4 0.75332 28.6899 15.9164 -2.28927 1.65734 -1.12046 +7349 4 1.88381 28.6368 14.9104 18.6776 -39.2188 -53.7174 +7350 6 41.7212 4.09992 39.5909 -11.2791 25.9615 -27.213 +7351 4 41.4168 4.81457 38.9155 6.653 -41.6332 33.8875 +7352 4 40.9635 3.53859 39.8438 1.60091 7.46224 -7.31473 +7353 6 28.6931 41.7984 21.1891 -6.68751 -8.42641 -4.80462 +7354 4 29.0735 0.780303 21.3271 9.25035 -16.558 -3.13259 +7355 4 29.3834 41.1221 21.0106 -2.7364 22.7931 4.70591 +7356 6 11.6395 12.4176 35.4525 -19.931 13.6599 -6.89173 +7357 4 11.6974 12.2316 36.3791 0.0383878 -4.43782 22.0781 +7358 4 12.5438 12.3774 35.1867 22.2579 1.64914 -11.6458 +7359 6 9.79005 12.0613 0.287125 39.0331 19.741 15.6941 +7360 4 10.6741 12.3652 0.649112 -24.288 -6.9143 -28.8601 +7361 4 9.37178 11.7496 1.07064 -16.9981 -12.0004 12.0483 +7362 6 48.1738 12.4001 9.21087 -14.7098 16.6281 -3.51107 +7363 4 48.3046 11.757 8.50338 5.36034 -5.93883 0.971929 +7364 4 48.886 12.3441 9.8545 11.7295 -7.72549 2.46367 +7365 6 20.1355 24.3829 18.9522 12.9308 -0.734849 -39.1055 +7366 4 19.4937 23.7815 18.5135 12.9255 8.80461 9.87411 +7367 4 20.8069 24.6162 18.234 -21.1698 -7.06963 26.7537 +7368 6 16.5393 31.2961 16.4761 -1.92172 -19.5246 -12.7122 +7369 4 16.66 32.2288 16.679 -4.64409 4.5232 17.4599 +7370 4 16.1207 30.7474 17.1716 1.36469 17.4989 2.94612 +7371 6 1.78169 14.6393 36.2977 19.9207 14.6923 -9.09136 +7372 4 1.03986 14.2937 35.8105 -15.9251 -7.35249 0.645581 +7373 4 1.68132 14.4688 37.2355 -8.64532 -4.94464 12.0587 +7374 6 4.36624 29.2084 29.5903 15.7403 17.1522 -11.4447 +7375 4 4.94475 28.7816 30.2313 0.42296 -3.8665 4.22363 +7376 4 4.9316 29.8996 29.1557 -19.5902 -17.4666 6.54186 +7377 6 43.6839 0.248111 22.6506 -19.7732 -13.3298 -9.50689 +7378 4 42.8764 0.661685 22.3065 0.028666 2.48852 1.60322 +7379 4 43.5183 41.2016 22.5042 11.2477 10.9397 1.57875 +7380 6 52.4994 40.9828 27.2386 -0.538127 -6.12089 -28.931 +7381 4 52.76 40.8447 26.286 -9.02638 3.90908 21.7421 +7382 4 53.2684 41.4137 27.6303 2.05735 4.02476 1.85103 +7383 6 25.5814 23.8969 27.7396 -24.7861 2.98762 0.531627 +7384 4 24.718 24.3642 27.6072 20.4038 -13.4527 4.15226 +7385 4 26.2821 24.4835 27.457 3.8963 1.45656 -1.88052 +7386 6 23.1228 17.031 33.3243 -5.52517 1.23961 5.4323 +7387 4 23.1399 17.5083 34.1558 0.441881 0.23205 -0.480567 +7388 4 22.8557 16.1383 33.5546 -4.67547 -8.64305 1.56256 +7389 6 2.92722 11.8725 21.3561 -41.4423 -19.1296 -19.7046 +7390 4 2.18606 11.2638 21.6443 29.5918 21.1066 -8.34803 +7391 4 3.54191 11.9259 22.0595 17.1072 -0.484489 21.5157 +7392 6 2.18317 4.15265 30.0257 5.779 -9.3787 -10.7468 +7393 4 2.12921 5.11001 30.0802 -2.76576 12.2821 -0.843831 +7394 4 2.67493 3.96573 29.2018 -3.29095 2.88479 4.98522 +7395 6 26.6728 30.2949 13.4768 7.17255 0.654769 14.1147 +7396 4 25.7117 30.2905 13.6467 8.22624 -2.44269 3.31295 +7397 4 27.1112 30.3188 14.3546 -11.9073 -0.623098 -17.8849 +7398 6 24.8734 30.8117 10.8292 -29.6944 -3.60301 -2.53615 +7399 4 25.2254 30.0431 10.3884 7.40196 -6.71761 -6.36825 +7400 4 25.5983 31.2424 11.2381 22.0508 11.6497 12.6203 +7401 6 53.1723 24.107 4.51212 -8.50651 -29.3458 16.902 +7402 4 53.5087 24.8189 4.00388 11.9327 21.9784 -14.7749 +7403 4 53.9335 23.6869 4.92936 2.49868 2.30602 2.88115 +7404 6 24.9006 4.49574 23.9943 -15.2803 12.8054 -1.91421 +7405 4 24.3197 5.26112 23.9044 -17.3839 -11.7779 6.16284 +7406 4 25.6928 4.95696 23.7819 42.3091 -2.82475 -3.31223 +7407 6 34.6808 1.64534 41.2582 -1.16689 -16.4189 -19.1193 +7408 4 35.6107 1.42238 41.0689 -7.35569 3.11738 8.02352 +7409 4 34.6894 2.06091 0.199506 5.11707 10.3461 19.9542 +7410 6 13.3318 19.5273 16.3875 10.456 -31.2285 9.008 +7411 4 13.8245 19.0713 15.6714 -4.89067 6.02882 4.66139 +7412 4 13.1633 18.7854 17.0362 1.8233 23.0525 -16.1268 +7413 6 48.6827 0.169575 20.4108 24.7259 -31.926 -14.6767 +7414 4 49.2893 41.6148 19.7702 -18.6338 21.3246 17.3218 +7415 4 48.933 41.6689 21.2514 -6.5025 5.85221 0.333279 +7416 6 43.0578 27.7881 11.5189 -10.6888 1.76469 -10.0665 +7417 4 42.6538 28.0077 10.6554 5.1393 -6.0393 10.108 +7418 4 43.5199 28.5835 11.7935 3.33621 0.984046 2.36511 +7419 6 25.7084 21.3766 35.1933 7.92601 18.71 -2.37973 +7420 4 25.8037 22.0957 34.5091 -5.30878 -22.9017 16.0752 +7421 4 25.4462 20.5484 34.7558 3.58761 11.0813 -0.636196 +7422 6 44.7325 4.60288 27.7529 -5.18995 0.47983 -9.95788 +7423 4 44.2388 4.02478 27.1463 1.34738 -4.40857 1.63455 +7424 4 44.3371 5.47709 27.6067 3.7052 -1.13476 4.16529 +7425 6 41.2786 11.441 34.2043 -0.416747 21.9122 -5.07112 +7426 4 40.7165 11.5703 33.4237 0.0697438 -4.14349 0.395824 +7427 4 41.2047 10.5155 34.4107 -4.51201 -19.8544 2.93408 +7428 6 19.8751 36.6454 2.03332 12.5662 31.6724 6.60432 +7429 4 20.6794 36.321 2.43856 -1.22315 -24.7147 -1.51883 +7430 4 20.0441 37.6041 2.15193 -20.0718 -8.75186 -9.57731 +7431 6 27.484 4.65653 6.35518 1.28922 -40.4385 -58.6648 +7432 4 27.5497 3.77116 6.72735 -1.75384 3.56143 11.9553 +7433 4 27.4257 5.33486 6.97498 -2.79123 31.4549 44.9969 +7434 6 16.8428 30.7659 39.9509 7.31092 -42.6244 -5.47757 +7435 4 16.9464 31.3097 40.7337 2.60533 1.47109 13.0941 +7436 4 17.1496 29.8303 40.1512 -5.48449 28.5555 1.20442 +7437 6 51.1542 15.2049 16.3406 35.1838 19.4064 -24.6303 +7438 4 51.2473 16.0791 15.87 -9.06363 -20.4986 13.944 +7439 4 52.0128 14.747 16.0894 -33.4595 8.32861 13.6861 +7440 6 49.9911 21.2271 35.9695 16.4294 -24.4585 13.2328 +7441 4 49.3547 21.5056 35.3276 -17.8928 6.13619 -17.6667 +7442 4 49.9245 20.2453 36.0087 2.29216 20.3869 -1.95357 +7443 6 34.4275 0.15221 5.68266 -0.837995 23.3079 0.855413 +7444 4 34.2957 0.929489 6.27037 2.93096 -11.6463 -16.4536 +7445 4 34.3488 0.459476 4.74482 0.623699 -7.30698 18.2278 +7446 6 48.316 11.5365 19.8846 -3.65813 -3.14803 11.8504 +7447 4 47.8503 11.3247 20.7373 6.31016 14.4835 -28.1035 +7448 4 47.7834 12.1052 19.2757 1.33379 -13.4076 20.6299 +7449 6 4.19577 39.4409 13.3607 25.3524 9.34899 10.5928 +7450 4 4.92582 39.74 13.9847 -33.0668 -7.48624 -17.3574 +7451 4 3.31127 39.5736 13.758 11.9971 1.78205 4.76714 +7452 6 8.7457 16.1809 8.53298 -1.62633 17.1572 -22.0575 +7453 4 8.74512 16.8853 9.19115 0.0519099 -7.3494 1.25428 +7454 4 8.72812 16.6658 7.66651 -0.023414 -16.7756 16.7144 +7455 6 29.0271 14.2712 26.5342 -13.8591 45.9397 20.1216 +7456 4 29.0757 15.2697 26.7309 6.93185 -43.1811 -12.6551 +7457 4 28.1042 14.0702 26.7795 9.9397 -3.04712 -3.53591 +7458 6 27.3813 14.5204 8.1419 -14.0666 1.8718 0.247246 +7459 4 26.4091 14.3966 8.10069 17.9482 5.30051 2.04476 +7460 4 27.5539 15.4689 8.31094 -4.76419 -14.5771 -1.3831 +7461 6 14.1301 27.2156 32.9232 24.3629 15.6041 -10.7258 +7462 4 14.926 27.3266 33.4685 -8.09546 -2.45296 -2.52419 +7463 4 13.4702 26.8045 33.4616 -14.5983 -10.6772 12.2116 +7464 6 31.6563 35.7792 21.2709 -29.1401 -25.1051 5.88501 +7465 4 32.0219 36.5153 21.7512 6.27263 14.1007 6.62418 +7466 4 30.8825 35.462 21.8184 22.9209 7.6802 -13.887 +7467 6 54.2186 28.7134 16.8958 -10.3287 11.0002 2.01575 +7468 4 53.5002 28.4234 16.309 3.24852 -2.61584 3.16662 +7469 4 53.9524 29.6107 17.1726 0.515277 -7.78004 -0.375364 +7470 6 9.0512 5.27483 17.1492 25.6572 1.38615 -17.9054 +7471 4 9.89534 5.12229 16.6101 -31.8522 3.085 22.1798 +7472 4 8.85255 6.23494 17.0921 1.81156 -15.0607 2.57474 +7473 6 29.6868 9.77258 26.5671 22.9889 -14.8503 10.4327 +7474 4 30.5444 9.2887 26.5838 -17.3341 11.3615 1.53321 +7475 4 29.3655 9.78642 27.4819 2.88877 -1.07091 -0.346791 +7476 6 44.0288 31.1766 32.1743 -14.2068 1.02328 22.4178 +7477 4 43.2475 30.9789 32.739 9.50682 -2.17476 -16.522 +7478 4 44.5788 31.7142 32.7564 8.88854 3.82935 -1.95952 +7479 6 53.49 3.62433 25.1454 11.2777 4.02107 -26.8953 +7480 4 54.1404 4.33507 25.1993 -2.49783 6.11479 15.045 +7481 4 53.6886 3.29227 24.2489 -10.294 -6.80459 12.4065 +7482 6 12.451 22.8746 3.38821 10.4278 8.96452 22.9237 +7483 4 12.7779 22.025 3.15024 17.1772 -24.972 1.67394 +7484 4 11.7815 22.9738 2.74712 -31.3784 16.165 -21.5343 +7485 6 39.42 29.6871 0.722943 17.2287 20.3893 -0.939439 +7486 4 39.938 29.1007 0.168548 -5.00448 -5.71086 -1.61555 +7487 4 38.6697 29.2119 1.03517 -14.5725 -11.7208 3.22357 +7488 6 13.7451 37.8179 23.0399 -3.65878 -32.3471 -6.65898 +7489 4 14.6418 38.0465 23.3627 -20.7195 15.519 -6.09735 +7490 4 13.1315 38.5597 22.9108 15.1185 11.2609 5.5967 +7491 6 33.3417 41.2334 -0.000336223 20.2285 27.8942 26.4667 +7492 4 33.8463 0.176253 41.7571 -17.5829 -26.3423 -4.93882 +7493 4 33.4991 41.0748 0.960438 -12.6248 -4.93214 -20.7453 +7494 6 15.7246 3.51737 6.33987 10.6879 -4.05507 31.4744 +7495 4 14.9251 3.29652 6.83809 -1.96505 1.65417 1.3128 +7496 4 15.4345 3.71468 5.4634 -8.944 6.24557 -22.4591 +7497 6 27.7713 30.7539 5.06912 -9.69485 -19.9648 -11.4393 +7498 4 28.5319 30.6575 5.66481 -7.77203 -4.90526 -3.90413 +7499 4 27.6074 29.8515 4.67882 9.36195 16.9347 11.4385 +7500 6 13.3277 7.57287 23.3467 18.1651 -5.37845 17.9429 +7501 4 14.1986 7.86136 23.0073 -11.0143 -2.49266 1.50668 +7502 4 12.7134 7.55433 22.6278 -8.93981 2.52131 -14.7715 +7503 6 38.3049 37.3174 27.9983 8.70135 -12.5747 15.655 +7504 4 38.3154 37.3922 27.0572 -6.74668 8.75695 -30.2201 +7505 4 39.0324 36.7087 28.1704 1.61648 -2.88985 11.5174 +7506 6 35.8266 12.5392 12.0897 -2.57405 -7.53067 12.8361 +7507 4 35.6491 11.5922 12.0112 2.97069 1.46586 -4.70523 +7508 4 36.2655 12.8127 11.2954 6.10525 2.83369 -11.8718 +7509 6 52.1153 23.0889 41.2774 53.3714 4.98692 -14.9993 +7510 4 52.5505 23.0114 40.3503 -31.9828 -2.74691 35.5054 +7511 4 51.1752 22.9201 41.2974 -16.3051 -5.99839 -13.4785 +7512 6 39.5458 11.6586 16.6081 -4.87816 2.10267 -34.9091 +7513 4 39.8889 10.7596 16.6462 4.61035 -3.54577 11.4771 +7514 4 39.4661 12.017 17.4857 2.58954 -3.33375 20.5696 +7515 6 0.680688 9.01153 7.97148 24.3969 36.1639 -33.0882 +7516 4 54.7452 9.01592 8.14854 -24.8099 -10.5681 8.91807 +7517 4 1.15172 8.32837 8.40327 2.66278 -26.2854 21.5078 +7518 6 42.3319 28.747 39.482 14.4944 54.9029 13.7373 +7519 4 41.6099 28.5069 40.0315 -24.977 -16.9351 14.372 +7520 4 42.5658 28.0062 38.9777 10.1954 -37.5926 -27.6332 +7521 6 38.7351 30.2774 16.2793 4.0737 2.19128 11.2593 +7522 4 38.8758 29.8829 17.1681 -0.562728 7.98522 -10.8415 +7523 4 39.3736 31.0181 16.2214 -9.64538 -12.7452 3.65311 +7524 6 7.59373 18.0328 0.655349 -39.2466 -13.429 1.02247 +7525 4 7.12412 17.545 1.38102 15.2508 10.2608 -15.5396 +7526 4 8.49503 18.0746 0.920891 28.7098 -1.69475 13.4339 +7527 6 33.7283 34.5883 24.1367 2.81913 -0.677006 -1.55035 +7528 4 33.5209 35.3543 23.5868 -0.36085 -2.23271 3.31185 +7529 4 34.0202 34.925 24.9956 3.1898 -0.550642 -1.12415 +7530 6 16.0108 40.0553 39.5926 -11.937 1.54577 -14.812 +7531 4 16.9471 40.1686 39.433 15.7688 -0.191962 4.71606 +7532 4 15.632 40.0274 38.6953 -1.55756 -1.47356 6.94311 +7533 6 4.49381 37.1265 21.8421 33.1234 -31.7004 -39.5319 +7534 4 4.78916 37.7556 22.4729 8.60512 21.3704 21.7375 +7535 4 5.32421 36.8863 21.3047 -36.9575 7.65083 16.8008 +7536 6 39.2568 20.1405 31.3294 -11.3601 -2.01094 -17.3558 +7537 4 39.2441 20.8952 31.9186 1.64276 10.2876 11.6417 +7538 4 38.6708 20.3662 30.5789 5.24327 3.39586 9.04201 +7539 6 28.5615 6.15748 32.0463 -1.77815 -13.6106 -5.56393 +7540 4 29.3688 6.39317 32.5024 4.03477 3.32162 5.90581 +7541 4 28.0645 6.97719 31.936 3.86184 3.53187 3.02469 +7542 6 9.32925 11.326 38.2021 -45.7357 8.82179 -18.9514 +7543 4 8.63026 12.0506 38.2047 26.1946 -20.5574 6.08922 +7544 4 8.95275 10.6938 37.5333 17.8336 11.1262 12.3014 +7545 6 41.6094 10.4714 6.86105 10.1449 -2.02989 30.4141 +7546 4 41.8033 10.1647 7.80154 -6.16714 11.7455 -31.3638 +7547 4 41.7667 11.4361 6.82819 -2.03628 -11.6206 -3.02795 +7548 6 3.11959 28.1093 17.6239 10.7497 -46.175 24.4008 +7549 4 2.68352 28.5892 16.9552 -19.7085 26.1099 -29.6067 +7550 4 3.57016 28.7359 18.1797 1.91623 14.188 4.79643 +7551 6 39.3448 12.237 19.2548 -14.1137 14.4353 18.1644 +7552 4 39.3198 13.2124 19.4672 -0.23776 -25.4214 -5.72266 +7553 4 38.5957 11.8144 19.7397 13.7352 7.639 -10.0067 +7554 6 2.76578 9.12322 31.711 10.2249 -26.7767 20.5709 +7555 4 3.2959 8.42892 32.18 -23.1647 11.967 -1.06293 +7556 4 3.41205 9.47362 31.1162 6.35119 16.2437 -14.7539 +7557 6 47.0978 34.3186 24.1743 26.4285 -20.6373 22.1669 +7558 4 47.9222 34.8155 23.9694 -26.3889 2.76484 -4.38573 +7559 4 46.3048 34.7125 23.8251 -6.69439 19.4391 -11.1209 +7560 6 41.2781 35.6191 9.5379 -9.82526 -0.200667 -5.59214 +7561 4 40.3156 35.6289 9.77314 20.3165 9.2235 -0.933793 +7562 4 41.677 36.5159 9.62264 -17.3348 -12.0484 0.717846 +7563 6 20.4662 31.4486 3.15039 -21.7086 3.64016 -5.07598 +7564 4 21.0332 31.2208 3.90109 -5.23001 0.711793 3.99895 +7565 4 19.5233 31.6154 3.43158 26.7394 -6.53789 -0.258783 +7566 6 33.2215 17.9623 24.8097 -0.453891 -1.34226 7.30289 +7567 4 34.1788 17.9667 25.0617 -18.0356 9.24084 -3.8919 +7568 4 32.8105 18.8566 24.8334 12.2893 -13.6267 3.75162 +7569 6 40.152 39.887 35.7648 -20.6867 7.32712 26.7748 +7570 4 39.5869 39.7633 34.9934 2.3303 1.35559 2.0998 +7571 4 39.5428 40.1203 36.5292 18.9615 -7.74514 -25.9591 +7572 6 4.86846 34.7127 16.4904 2.99496 1.45153 -7.51648 +7573 4 4.94748 35.6438 16.2302 0.473437 -5.16658 -0.520329 +7574 4 5.67201 34.2663 16.1683 2.12015 0.152524 1.06444 +7575 6 19.1332 11.0374 26.5471 0.604362 14.7011 2.3555 +7576 4 19.0986 10.7741 25.6217 -2.73437 -5.06461 -1.05922 +7577 4 19.4813 10.3027 27.0576 -1.53582 -10.5153 -0.687646 +7578 6 54.0201 13.9196 34.7874 -7.69802 -2.07317 -2.05829 +7579 4 53.0764 13.9769 34.9536 -3.33021 -5.1824 4.14914 +7580 4 54.0417 14.262 33.8952 13.8623 5.56658 -9.2157 +7581 6 1.84699 20.6587 5.20972 14.9439 0.361847 -39.2318 +7582 4 1.3018 19.9191 4.88605 -0.816153 4.45331 11.6833 +7583 4 2.38828 20.8916 4.39492 -13.6739 -1.13034 29.3331 +7584 6 22.2428 0.0912174 14.2544 2.10511 -1.36215 24.2926 +7585 4 21.4939 0.626329 14.4934 -11.4394 6.88953 -7.77601 +7586 4 22.6568 41.86 15.1175 2.53583 -3.69112 -10.285 +7587 6 4.95629 7.04242 24.7427 6.31781 -9.23371 -7.19194 +7588 4 4.17782 7.32111 24.2434 0.969413 4.1364 5.47863 +7589 4 5.24611 6.21648 24.3187 1.32276 5.05146 9.71893 +7590 6 41.4805 20.8726 34.9438 -11.2314 22.7349 11.4525 +7591 4 42.1022 20.1554 34.9949 12.4759 -11.6791 0.0999164 +7592 4 41.5325 21.3468 35.8092 3.20944 -13.6901 -15.0483 +7593 6 28.2157 1.74547 31.725 -9.95228 -2.94536 5.02618 +7594 4 27.5723 1.08944 32.0352 4.54694 0.234407 -12.282 +7595 4 28.3302 2.26918 32.5198 6.68924 9.49254 2.75715 +7596 6 16.8899 27.3746 36.9858 -9.49677 -4.03922 3.2671 +7597 4 17.2157 28.1459 36.4964 2.86939 -7.49192 -2.31982 +7598 4 17.0938 26.5386 36.5152 1.89463 15.2676 -1.69393 +7599 6 26.8243 38.069 8.34482 13.7761 41.6132 3.1747 +7600 4 26.4823 38.3279 9.22598 3.84792 -18.6223 -11.4711 +7601 4 26.785 37.1424 8.19579 -7.88027 -37.9853 9.71444 +7602 6 26.6634 33.7911 23.2273 -21.2745 -8.43567 7.74896 +7603 4 27.1019 33.3181 22.5212 7.04537 -0.372104 -6.32159 +7604 4 27.3305 34.169 23.7872 14.5385 6.50935 5.10733 +7605 6 10.2166 27.1183 30.2276 16.2509 -17.1331 -9.46175 +7606 4 10.1765 28.0583 30.3796 2.29392 15.9864 2.71565 +7607 4 10.9387 26.9511 29.5696 -14.5483 8.58048 15.0042 +7608 6 47.87 12.5975 5.02268 -6.13754 10.9902 -1.31963 +7609 4 48.1357 13.4822 5.34438 -4.36861 -17.8106 0.719643 +7610 4 48.2725 11.9144 5.56853 6.38614 1.6905 7.47062 +7611 6 53.3393 24.5639 22.1523 -40.2275 -1.43509 1.91788 +7612 4 53.1884 24.513 23.11 6.12251 -0.709171 0.80005 +7613 4 54.2538 24.6676 21.944 28.1496 2.10984 1.66559 +7614 6 29.4072 10.7569 19.3822 52.4151 15.8336 -9.71081 +7615 4 29.248 9.98119 18.8618 -10.0643 -15.3346 -6.0739 +7616 4 28.6282 10.9567 19.8417 -45.3483 4.87471 22.9978 +7617 6 39.4757 14.9522 19.5461 30.0359 -1.30311 42.0602 +7618 4 40.386 15.231 19.9108 -38.5728 -7.77311 -23.4682 +7619 4 39.3498 15.357 18.6983 1.75067 15.7407 -16.9704 +7620 6 32.8823 15.9838 22.806 -0.988113 9.61369 -4.64335 +7621 4 32.9657 16.5376 23.5815 3.43203 16.8704 5.79609 +7622 4 32.7087 15.1359 23.1895 -5.55033 -22.0541 3.57771 +7623 6 30.5481 1.96835 21.5144 8.4955 -1.31523 7.25762 +7624 4 30.7645 2.06729 22.4547 -1.5525 1.72807 -3.05596 +7625 4 31.3563 1.607 21.1075 -12.3766 3.94884 0.453046 +7626 6 0.972615 11.9937 3.31932 2.75381 16.0475 9.69945 +7627 4 1.12058 12.9582 3.29011 -6.67466 -9.20629 -8.78254 +7628 4 1.16803 11.7633 4.23669 1.49118 -7.35844 2.879 +7629 6 32.1487 30.4035 20.7885 -10.2937 2.79415 -8.64413 +7630 4 32.9584 30.6778 20.3377 1.19491 2.22071 -1.75985 +7631 4 31.4018 30.7106 20.2304 12.8433 -5.61998 7.3235 +7632 6 5.36663 35.5196 9.0005 -13.7636 -10.8617 -1.51226 +7633 4 5.10558 35.6694 8.09522 3.88385 7.21083 -8.97177 +7634 4 4.84313 34.7327 9.21079 3.19207 0.561776 9.20467 +7635 6 49.9075 13.051 32.2032 24.7068 -1.78611 -22.7634 +7636 4 50.5917 12.8604 31.4934 -20.1594 10.2365 23.451 +7637 4 49.3072 12.3042 32.1357 -5.12737 -3.80929 6.93874 +7638 6 4.31321 24.0956 1.58545 -15.4175 -15.0012 -21.2972 +7639 4 3.62325 24.7374 1.73273 -2.73087 12.0747 8.21305 +7640 4 3.96758 23.5799 0.823479 15.3265 9.07188 13.8923 +7641 6 44.1581 38.1227 12.3545 -1.42535 -29.4608 0.820402 +7642 4 43.4877 37.5183 12.7749 7.78878 22.0847 -6.23147 +7643 4 43.9706 39.05 12.5061 -8.83193 8.8938 6.46859 +7644 6 44.688 17.3349 22.7943 52.857 -4.21013 7.29678 +7645 4 45.2391 18.0521 23.242 -20.6522 -19.8992 -14.1432 +7646 4 45.3699 16.6167 22.57 -26.4285 25.231 9.0384 +7647 6 20.3608 11.6914 19.667 7.58964 -15.1508 -20.1027 +7648 4 20.0231 12.466 20.0832 -9.22037 21.7722 17.9466 +7649 4 20.541 12.011 18.7627 0.78957 -9.8802 4.31695 +7650 6 4.45783 15.4051 36.2022 4.17523 -10.6616 -1.13379 +7651 4 5.07913 14.7124 35.8925 -4.22209 9.46347 0.0108161 +7652 4 3.57023 15.0045 36.1544 3.18966 5.51307 1.04981 +7653 6 44.8105 39.5245 30.1712 -12.2097 -12.5983 -29.4865 +7654 4 44.6649 39.2374 29.2388 12.2423 8.81859 19.2473 +7655 4 44.0848 39.0946 30.6384 -0.298867 5.38951 7.86823 +7656 6 30.0635 3.50956 11.3278 16.0802 -2.39158 -40.3094 +7657 4 30.5444 4.30508 11.007 -11.8296 -5.04519 20.5985 +7658 4 30.1379 2.92562 10.5291 -8.6007 1.99314 24.6663 +7659 6 25.6288 24.8657 16.1423 35.3146 -5.68436 -0.158812 +7660 4 26.5897 24.7732 15.9989 -9.69879 -4.30362 -13.2764 +7661 4 25.6615 25.1054 17.0605 -14.6317 7.6504 23.2411 +7662 6 36.8074 29.8609 20.6529 -16.3286 -4.81766 17.6852 +7663 4 35.9316 30.2459 20.3982 14.0867 -8.19012 9.60149 +7664 4 36.7164 29.3161 21.4988 -1.56746 21.2483 -31.978 +7665 6 52.2273 17.0565 38.3075 -18.6216 -30.1938 15.1193 +7666 4 51.4912 16.4635 38.6201 23.7372 14.7716 -7.00173 +7667 4 51.7959 17.5937 37.6524 -0.777677 7.661 -6.77585 +7668 6 3.82637 23.6296 29.8591 26.0466 24.015 14.1033 +7669 4 4.67122 23.3872 29.4436 -4.98409 -4.75234 -2.50433 +7670 4 4.14214 24.3103 30.5173 -20.0237 -17.5461 -14.7603 +7671 6 6.36694 19.9104 41.0994 -7.87156 6.69529 -0.551213 +7672 4 6.75531 19.2216 41.6418 3.91706 -4.8357 7.00798 +7673 4 6.43687 20.7189 41.61 0.371167 5.3541 9.12827 +7674 6 28.9069 38.9219 35.3342 18.1363 5.4885 19.4373 +7675 4 28.4975 38.2544 34.8057 -13.0204 -17.6003 -18.1497 +7676 4 29.7244 38.4883 35.6529 -6.84193 6.3312 -4.3373 +7677 6 1.06391 30.294 34.4744 17.4659 -4.25802 33.126 +7678 4 0.923806 29.8092 33.6831 -4.92213 -16.9626 -31.6436 +7679 4 0.43107 31.0027 34.4841 -13.3738 11.5818 -2.38269 +7680 6 26.4433 22.0338 20.438 10.4135 -19.5508 3.73058 +7681 4 27.3849 22.2767 20.3653 -17.5193 8.20183 -1.91668 +7682 4 25.8117 22.75 20.2981 5.30742 7.62512 -2.77887 +7683 6 3.9439 18.647 22.686 19.6053 -30.212 14.064 +7684 4 4.76982 18.631 23.2404 -22.0254 9.00566 -12.7221 +7685 4 3.71052 19.5535 22.5456 -1.30938 28.7031 -1.82281 +7686 6 6.87955 39.3273 26.9921 -1.67667 -12.9446 -11.9216 +7687 4 7.1836 39.9129 27.6984 -12.429 3.42242 7.34442 +7688 4 5.90054 39.2886 26.9896 13.9064 15.8094 12.8698 +7689 6 43.976 41.7556 26.5281 4.8347 -4.89589 -5.39334 +7690 4 43.9038 0.242071 27.3891 4.48323 5.1383 20.2804 +7691 4 43.1144 41.9148 26.1591 -17.5097 2.26447 -13.804 +7692 6 31.7137 29.57 16.9845 -29.8695 1.84649 5.70955 +7693 4 31.0051 28.8814 16.8861 15.511 13.0746 -1.88966 +7694 4 31.2475 30.3377 17.3963 12.872 -19.7765 -2.8161 +7695 6 46.2467 10.9544 15.5549 14.6537 -15.0388 13.4913 +7696 4 45.2992 10.7621 15.4719 2.35584 -6.3837 2.44855 +7697 4 46.7422 10.1008 15.6673 -18.7057 18.8904 -8.1417 +7698 6 36.5806 15.025 25.8165 21.8026 1.76557 9.13915 +7699 4 37.3648 15.4873 26.2149 -21.7037 -15.0217 -10.3096 +7700 4 36.1201 14.6319 26.5704 -2.31195 -1.95921 2.19148 +7701 6 47.2758 22.6707 6.12549 -20.393 21.5378 -17.5673 +7702 4 46.5536 23.2672 5.80637 16.9751 -15.6011 5.88158 +7703 4 47.0174 22.4855 7.02503 2.56882 -3.04752 8.65489 +7704 6 27.5281 39.6653 17.8063 9.11062 13.5998 -14.667 +7705 4 26.6008 39.6971 17.5421 -9.18871 -3.65478 0.40423 +7706 4 27.5952 39.1072 18.5692 -4.91094 -8.97362 13.813 +7707 6 14.0432 27.9674 36.8911 6.42031 -13.692 3.20322 +7708 4 13.4093 27.2386 36.6831 22.3711 16.0651 -1.21324 +7709 4 14.9745 27.6178 36.9209 -23.5128 3.35359 -2.56993 +7710 6 33.7582 13.0225 13.8549 2.82411 10.3644 -10.1378 +7711 4 34.6192 13.1187 13.3682 -26.1927 -14.0119 11.7219 +7712 4 33.447 12.1034 13.9061 16.5995 3.21583 -3.74575 +7713 6 3.39066 17.4794 1.96807 -11.027 -24.2448 -29.9928 +7714 4 3.01559 16.7425 1.36999 17.4474 35.7284 24.3857 +7715 4 3.43148 18.2603 1.39088 -0.910914 -5.0095 5.82543 +7716 6 27.5636 2.76805 36.4448 23.3016 6.40537 7.49337 +7717 4 28.0874 2.94382 35.6362 -14.0128 -4.70143 5.95918 +7718 4 26.7201 2.39292 36.1778 -1.1877 -0.145823 -5.22631 +7719 6 21.3174 1.20043 18.721 3.60184 -34.5623 26.1973 +7720 4 20.9731 2.06802 18.64 -8.90193 33.3239 -10.7294 +7721 4 20.989 0.903829 19.6038 6.52339 -1.5964 -17.0558 +7722 6 11.8953 16.678 29.2972 -24.0209 -12.1876 15.7906 +7723 4 10.9907 16.5502 28.9196 20.2967 4.53139 4.03679 +7724 4 11.83 16.2797 30.2084 5.50538 14.3948 -24.2902 +7725 6 15.9723 29.4609 29.6333 0.682268 26.1612 18.9471 +7726 4 16.8848 29.3174 29.3467 -1.47573 8.2327 2.84191 +7727 4 15.9822 30.2485 30.2615 3.64459 -27.0302 -18.4378 +7728 6 42.9269 7.03734 4.5197 11.663 -6.03152 6.53833 +7729 4 43.4231 7.50219 3.8104 -1.91258 -11.2042 14.7177 +7730 4 43.564 6.5391 5.10838 -14.9069 13.4822 -19.2581 +7731 6 46.4099 26.3175 18.5001 -14.65 2.77244 -10.2078 +7732 4 46.6739 27.1133 19.0164 -10.4759 -17.1195 -12.5948 +7733 4 45.7242 26.5969 17.8403 16.3643 -1.95791 15.5671 +7734 6 26.8576 31.9381 30.1176 11.4414 -26.9795 -35.8502 +7735 4 27.1259 30.9869 29.8859 -9.79711 36.6724 15.314 +7736 4 26.5998 32.3006 29.2227 5.46388 -10.7605 29.9307 +7737 6 19.4818 37.6192 31.2596 -32.5143 -22.3469 33.0613 +7738 4 19.0962 36.8501 30.8088 8.72557 8.52431 -5.84089 +7739 4 19.0944 37.5229 32.1795 16.9146 13.3756 -22.466 +7740 6 52.3665 32.7318 12.7942 -5.34222 7.33615 -3.08781 +7741 4 51.884 32.8768 11.9489 17.9119 0.95058 7.1847 +7742 4 53.27 33.1068 12.8183 -18.0778 -3.45769 -11.3622 +7743 6 6.73992 9.26339 24.0285 -18.4022 -33.2824 -0.456279 +7744 4 6.43016 9.52976 23.1488 2.39009 0.543925 -1.37305 +7745 4 6.14044 8.50785 24.2751 15.0572 15.2043 -3.93749 +7746 6 39.7373 39.5658 25.499 -11.0807 -5.52867 0.517577 +7747 4 39.7453 38.628 25.2585 2.77876 5.57729 -0.31401 +7748 4 38.826 39.699 25.8216 4.65786 0.889055 -1.26295 +7749 6 24.0734 14.0105 21.1438 13.9648 5.3121 -25.5312 +7750 4 23.6065 13.6215 21.8839 -3.42696 -11.6299 6.48748 +7751 4 24.3304 13.3134 20.491 -9.48085 14.6929 20.6508 +7752 6 5.1987 41.7736 24.8713 10.0047 -19.0707 10.1325 +7753 4 6.05769 0.0475547 25.2635 0.547146 -1.74599 -5.91735 +7754 4 4.86042 0.69526 24.5593 -4.41349 12.4443 -5.8689 +7755 6 42.3687 20.86 21.2777 19.2234 -22.1312 -1.40502 +7756 4 42.3783 20.5581 22.1846 0.624409 -1.73106 8.2154 +7757 4 41.7113 21.532 21.2665 -20.5735 20.428 -5.9858 +7758 6 48.2425 15.3687 33.5924 -0.241089 -2.38933 -5.28694 +7759 4 48.6415 14.7162 33.0072 6.18243 -4.87195 3.86709 +7760 4 47.6596 15.8553 33.0028 -7.11438 7.34599 -0.780278 +7761 6 46.0202 38.2953 16.5865 15.7829 17.4793 7.01852 +7762 4 46.7193 37.7552 17.0318 -13.8218 15.7663 -8.05182 +7763 4 46.1673 39.253 16.8241 -2.73609 -24.364 -6.22008 +7764 6 4.62701 28.4898 21.3631 -35.4199 -38.8764 -1.71187 +7765 4 5.05003 28.7578 22.1614 14.3175 13.903 20.3467 +7766 4 4.23296 27.6059 21.6238 11.0236 23.568 -16.8729 +7767 6 20.5692 15.1618 18.3974 -2.72234 -3.16682 18.7699 +7768 4 20.0205 15.9086 18.1633 -0.374776 9.93651 -8.10169 +7769 4 20.1114 14.8073 19.1799 7.71486 -3.14336 -3.02048 +7770 6 16.2446 13.6415 17.4737 -35.4034 4.06645 -23.9936 +7771 4 16.1835 14.6144 17.5029 6.20848 -12.1 -0.082548 +7772 4 15.5556 13.4035 16.7727 24.4056 2.85778 27.0666 +7773 6 52.5084 30.9566 18.1567 -0.97573 -12.5044 17.346 +7774 4 52.0533 31.4717 17.4985 -6.50351 10.4198 -16.9401 +7775 4 51.7821 30.6074 18.6971 11.4062 2.54252 -4.46582 +7776 6 24.418 1.73203 15.7939 2.07222 -10.1482 7.47229 +7777 4 24.2447 1.14878 16.5739 0.390494 16.7143 -9.44633 +7778 4 24.1366 2.64887 15.952 -0.929678 -6.23215 5.34629 +7779 6 23.8719 5.08832 31.0744 22.7283 -21.9769 -16.2257 +7780 4 23.8146 5.92648 31.5054 -7.3092 22.9653 9.22328 +7781 4 24.8319 4.92382 30.9303 -16.6577 0.531409 1.66203 +7782 6 29.6615 30.9343 0.410524 16.5859 -5.2272 -6.83283 +7783 4 30.4171 30.5602 -0.0763344 -8.98044 0.909776 12.9407 +7784 4 29.1293 31.2514 41.5907 -13.3941 8.54792 -1.14443 +7785 6 32.8591 37.9003 22.5268 -10.9299 -3.56267 -2.34485 +7786 4 33.7082 38.1164 22.1304 5.81458 1.66065 7.83892 +7787 4 32.835 38.1832 23.4516 6.53001 6.08896 0.386172 +7788 6 16.4762 17.3653 33.758 -11.7596 5.685 -6.41316 +7789 4 15.9639 18.0545 33.2621 15.6067 -10.6469 10.7903 +7790 4 17.1589 17.009 33.1621 -6.01342 7.59956 -1.04496 +7791 6 9.22918 13.3839 27.5418 -13.213 -9.30661 16.5651 +7792 4 8.30942 13.5198 27.2923 -4.71042 4.84624 -13.6557 +7793 4 9.0972 13.1179 28.4658 14.0632 -0.809421 3.61995 +7794 6 43.4685 7.73978 17.2176 -8.6426 5.21856 8.44668 +7795 4 43.4054 7.77113 18.1985 3.14312 -1.73226 -22.4674 +7796 4 44.4071 7.82788 17.0033 -0.931382 -0.0897333 1.197 +7797 6 22.3132 24.3412 23.1703 -9.75348 13.1727 -0.0757149 +7798 4 22.7871 23.5122 23.2675 1.8966 -9.89464 -1.11237 +7799 4 21.5045 24.1854 22.6454 4.5924 -1.52242 4.18414 +7800 6 26.0037 32.9236 32.716 -4.33416 -0.788049 -7.61174 +7801 4 26.2455 32.6516 31.8136 -0.0498336 0.850388 -0.133699 +7802 4 25.1949 32.4304 32.9126 -0.360701 -0.787143 2.76329 +7803 6 16.9426 19.041 7.45715 -3.10994 24.472 -2.41526 +7804 4 16.308 19.3093 8.14456 3.13816 -6.91205 -2.30089 +7805 4 17.0114 19.8381 6.87129 1.57938 -24.3813 10.2947 +7806 6 48.1131 14.4569 27.5699 7.08917 8.35207 6.49885 +7807 4 48.0603 15.1245 26.8691 -1.5138 -4.18476 1.16992 +7808 4 48.1537 14.9494 28.4126 -1.96213 -3.76556 -9.73571 +7809 6 52.3834 41.7541 11.1123 -0.447482 12.3 22.2377 +7810 4 52.3153 0.228199 10.2442 -0.817032 7.00513 -16.5207 +7811 4 52.6623 0.571857 11.7011 -4.41087 -5.87968 -8.23494 +7812 6 36.3325 6.93202 12.7048 -8.66608 5.7588 -1.53482 +7813 4 36.3873 7.88419 12.9074 5.41886 -9.49824 0.0534512 +7814 4 37.2464 6.6206 12.6662 3.93968 -0.5832 -0.272047 +7815 6 8.24609 20.3242 16.6676 2.28714 -8.73249 -3.11806 +7816 4 7.99607 19.3797 16.5602 0.915774 9.85224 4.30221 +7817 4 9.21956 20.3717 16.6442 -3.81833 -2.78155 -1.09608 +7818 6 28.8059 40.3215 12.8316 -6.32157 -2.99739 9.80695 +7819 4 29.5356 40.2333 12.2314 15.0973 -2.52646 -11.1155 +7820 4 28.4555 39.4209 12.8947 -4.4969 5.39171 3.74805 +7821 6 18.1648 11.8204 16.9538 6.42365 10.4423 10.6103 +7822 4 17.6537 12.6149 17.1793 -7.21931 -10.1359 -1.31065 +7823 4 19.063 12.1656 16.925 9.05203 -3.86377 -1.18548 +7824 6 30.8803 17.4233 21.4874 -38.9186 -21.5127 -11.6054 +7825 4 30.1793 16.7188 21.4067 15.4039 25.3522 4.50617 +7826 4 31.5864 16.9116 21.8642 20.5617 -1.86838 10.7411 +7827 6 34.8073 19.4112 37.959 10.4013 19.2527 -16.7989 +7828 4 34.9062 20.1671 37.3279 -0.177011 -16.5385 16.965 +7829 4 34.2544 18.768 37.5084 -3.31564 -7.45818 -3.12702 +7830 6 35.8251 16.8879 29.2053 19.9429 8.12055 25.1888 +7831 4 36.604 16.4922 29.6427 -6.21008 5.15879 -2.88988 +7832 4 35.5164 16.1914 28.6524 -12.7517 -21.289 -18.0185 +7833 6 3.03682 32.2806 6.33235 -9.22618 28.6071 10.2197 +7834 4 2.10307 32.1357 6.11945 6.4331 -12.4482 -1.5948 +7835 4 3.56193 31.5065 6.1559 2.8275 -21.5224 -7.32445 +7836 6 26.8 41.6522 10.1614 16.4152 -10.6242 6.62789 +7837 4 27.6763 41.4103 9.75871 -19.2491 6.11251 13.5217 +7838 4 26.9685 0.0827479 11.0562 4.26354 0.263175 -7.76775 +7839 6 52.2755 24.564 24.8743 -17.4742 4.09161 11.4913 +7840 4 51.3068 24.6875 24.9545 12.6777 -6.48001 -7.54331 +7841 4 52.5704 24.9086 25.7267 7.88636 1.59704 3.61539 +7842 6 22.6859 22.6471 33.5865 3.00815 -0.389016 -3.70522 +7843 4 23.2377 23.2516 34.129 -18.2936 -9.34398 -1.8364 +7844 4 21.8798 22.3666 34.0572 9.18357 8.33181 5.74035 +7845 6 10.6559 14.2334 33.0439 8.40108 -6.88321 -2.71679 +7846 4 10.5166 14.9368 32.4181 8.42324 10.9453 -12.1325 +7847 4 9.76709 14.0756 33.3137 -17.8131 -11.8211 11.2552 +7848 6 21.913 10.8504 11.5417 10.0273 5.1408 -10.1307 +7849 4 22.8643 10.6911 11.6864 -4.5907 0.219491 7.97275 +7850 4 21.4519 10.7503 12.3817 3.5408 -3.26695 13.1151 +7851 6 38.3604 6.02409 25.8423 -7.72295 28.2176 13.9057 +7852 4 38.0159 6.28095 26.7202 2.23326 -16.155 -4.56644 +7853 4 38.4362 6.90267 25.4438 5.48615 -7.56939 -11.5178 +7854 6 30.9465 26.6393 38.5732 9.04128 -30.5088 -25.1958 +7855 4 30.9128 26.4505 39.498 -1.67119 3.99535 28.8865 +7856 4 31.0441 25.726 38.2186 -4.36445 16.9712 0.749916 +7857 6 30.1667 14.6301 35.4838 10.1392 5.1159 -4.4805 +7858 4 30.5216 15.3681 34.9096 -25.1579 -14.4294 10.0398 +7859 4 29.1929 14.5877 35.5299 11.6839 11.6021 -8.75286 +7860 6 12.5351 37.2243 16.9695 -17.9994 -5.54058 0.759354 +7861 4 12.9667 37.9067 17.4519 9.84296 27.0859 15.3185 +7862 4 13.2146 36.5653 16.9126 10.1753 -19.489 -6.1469 +7863 6 27.4306 21.5582 37.7184 0.323044 -0.91237 -2.80926 +7864 4 26.8919 21.7087 36.9418 -1.95891 -4.49412 -14.6911 +7865 4 26.9535 22.0297 38.3943 0.198826 4.23191 11.3586 +7866 6 29.6082 18.3788 12.6829 -3.7237 -11.7076 25.6006 +7867 4 29.4829 18.1024 13.618 2.9495 3.49705 -16.1413 +7868 4 28.7034 18.5321 12.3984 -4.77545 3.00323 -3.28229 +7869 6 2.3585 15.6468 0.175999 -8.20612 37.5639 57.3692 +7870 4 1.52386 15.5898 41.6501 -20.1916 -9.73007 -21.8008 +7871 4 3.00191 15.1099 41.6903 28.5072 -35.3577 -30.6151 +7872 6 17.8194 25.7234 4.22068 -18.7286 -4.35761 2.03057 +7873 4 16.8619 25.5897 3.93795 36.6055 5.10926 -2.3659 +7874 4 18.4291 25.8425 3.4621 -13.2431 -0.0346718 7.72723 +7875 6 41.7912 11.1794 20.2704 -4.7703 -4.22644 -3.97484 +7876 4 42.5222 11.2179 19.6258 -6.77094 -1.14571 2.2342 +7877 4 40.9861 11.4636 19.8126 1.73275 2.14556 -1.92771 +7878 6 38.0378 18.3863 24.0278 -3.74133 -10.331 -0.132081 +7879 4 38.4309 19.0888 24.5482 3.22643 8.24914 5.57345 +7880 4 37.9308 18.7305 23.1431 0.767244 4.53126 -6.25669 +7881 6 4.13298 13.9173 33.7521 30.6843 -35.3272 -10.2657 +7882 4 3.2388 13.7394 34.0326 -6.45696 -6.01886 0.999898 +7883 4 4.62487 13.0231 33.6052 -30.6419 39.0128 7.66426 +7884 6 19.1936 19.1847 26.5022 -1.72621 -3.50471 2.07629 +7885 4 19.5259 20.0399 26.2155 5.41694 7.89262 1.74938 +7886 4 18.9505 18.7515 25.6854 -0.500338 -7.01675 -4.74744 +7887 6 22.475 26.1945 25.3345 -21.4458 -23.9003 -3.16659 +7888 4 22.3709 25.4906 24.6814 -7.32491 -4.57374 0.352876 +7889 4 23.3013 26.5414 25.0733 33.537 19.6696 -4.44151 +7890 6 48.8098 32.073 32.5556 -12.1052 4.48194 -0.190297 +7891 4 48.9381 31.1381 32.4233 -5.03309 -16.3747 0.495313 +7892 4 49.6354 32.4434 32.2762 12.9514 12.9364 -2.07298 +7893 6 25.2177 18.014 27.013 4.13139 4.11129 3.02633 +7894 4 24.4991 17.5573 27.49 6.6231 -0.568789 -7.074 +7895 4 25.6482 17.4406 26.3525 -8.92874 -1.57445 7.95973 +7896 6 1.76475 41.5608 24.9549 2.89162 -9.06076 -21.1384 +7897 4 1.88611 40.794 24.3317 -1.07403 19.5272 24.3581 +7898 4 1.30092 0.287142 24.3881 5.67761 -7.93757 11.1942 +7899 6 18.6633 11.7702 10.8608 -14.1102 -15.1967 11.3789 +7900 4 19.5021 11.9001 10.4051 -2.67857 -1.17934 -0.0567829 +7901 4 18.6465 10.841 11.1975 0.382459 20.6246 -9.54243 +7902 6 45.6242 16.5573 4.85031 17.0541 -2.39304 -3.72853 +7903 4 46.5701 16.2411 4.85652 -23.9929 13.0597 -1.64852 +7904 4 45.6057 17.5078 4.58964 5.38323 -15.7737 4.77093 +7905 6 40.6798 36.3894 24.0177 5.99482 15.2006 -18.5281 +7906 4 40.7505 36.8152 23.1136 -3.68852 -16.1642 25.9152 +7907 4 40.7388 35.4259 23.9735 0.360603 0.79119 -4.57544 +7908 6 32.2161 36.322 4.9431 5.19197 18.2152 11.0878 +7909 4 31.5074 36.1415 4.30154 10.9387 -10.0795 -6.57323 +7910 4 33.0257 35.7839 4.88769 -13.0089 -6.05715 -7.93038 +7911 6 1.60369 14.6754 10.8168 -10.3056 7.30247 33.6992 +7912 4 2.33423 15.3134 10.9307 -7.1595 -6.86026 -1.25923 +7913 4 1.1476 14.6845 11.711 13.0511 -0.847163 -26.6328 +7914 6 35.0153 14.2871 28.0739 18.7596 2.69464 30.5166 +7915 4 34.8734 14.0618 29.0187 14.279 3.49385 -12.2543 +7916 4 34.1456 14.1907 27.7398 -26.4062 -1.19123 -20.5956 +7917 6 54.7157 6.11907 21.8609 -12.1949 -7.16094 1.89291 +7918 4 53.7846 6.03827 22.1577 10.7478 1.95047 -3.13077 +7919 4 0.0370646 6.90146 22.3147 2.89466 7.98076 3.79048 +7920 6 31.7642 16.9274 27.3665 -7.54316 -5.52924 6.90942 +7921 4 30.8348 17.1206 27.2023 -9.34166 0.83246 -0.0222557 +7922 4 32.1928 17.2544 26.5838 13.9998 7.82105 -16.2222 +7923 6 14.4504 28.0052 11.1087 -4.71237 -14.6735 4.6077 +7924 4 14.1081 28.8557 11.3451 -9.65694 14.7183 8.34222 +7925 4 14.826 28.1745 10.2406 5.25389 -7.26775 -5.19981 +7926 6 35.6627 19.4906 18.309 1.38743 3.66357 1.00844 +7927 4 36.0608 19.4502 19.1905 -8.3289 1.62604 -1.04031 +7928 4 34.971 18.8114 18.299 7.41978 2.58016 -0.85803 +7929 6 0.908295 12.7232 15.4509 -10.2874 -45.1283 5.64528 +7930 4 0.635795 11.7526 15.3361 10.0925 35.0181 2.47128 +7931 4 1.39513 12.719 16.2997 -3.76012 1.73199 -7.91518 +7932 6 52.7239 14.8052 20.9911 -10.1838 -50.8962 13.8805 +7933 4 52.1355 13.9729 20.9263 20.4043 37.1153 -0.0771148 +7934 4 52.3678 15.481 20.4204 -9.75671 2.85516 -9.21068 +7935 6 7.50014 6.78453 13.6112 45.6118 -3.77462 -0.237279 +7936 4 7.66407 7.72531 13.7166 -11.095 5.64184 -2.33744 +7937 4 8.44113 6.46934 13.5548 -33.3093 -4.56257 -1.46213 +7938 6 12.8693 29.1327 30.951 -35.1999 43.7452 -37.9705 +7939 4 12.911 28.5157 30.2274 6.73286 -14.9776 0.757022 +7940 4 13.2432 28.8129 31.7306 26.8069 -31.1286 39.1504 +7941 6 8.91269 29.9946 35.6682 4.82638 -20.5676 13.9142 +7942 4 9.08199 29.9869 36.6487 -3.4848 12.9743 -23.6701 +7943 4 8.85763 30.8835 35.2999 2.4913 8.97671 5.8399 +7944 6 29.2501 7.21193 5.56384 -35.3124 23.3999 -5.45769 +7945 4 29.8929 6.567 5.7677 24.3163 -25.3556 4.38867 +7946 4 28.4878 7.00912 6.14468 16.2636 8.35776 -7.44031 +7947 6 25.8882 9.2493 3.85609 -10.1418 -10.3657 2.14015 +7948 4 26.6938 8.77544 3.58522 -5.62061 -1.52714 -0.987441 +7949 4 25.143 8.71761 3.5088 14.4855 4.13341 2.07026 +7950 6 46.1828 19.5303 23.8452 27.5142 -8.79556 18.2338 +7951 4 47.0303 19.3932 24.4147 -29.6641 11.3761 -34.952 +7952 4 46.4302 19.9015 22.9687 10.0609 -5.49214 13.8961 +7953 6 18.6 35.3226 28.7813 33.9262 -21.2248 5.29661 +7954 4 18.5078 36.1255 28.2543 2.15121 5.76995 -5.3877 +7955 4 19.5645 35.0126 28.755 -37.0827 17.274 -2.06568 +7956 6 28.0068 22.625 32.1882 17.1638 -9.71048 -11.652 +7957 4 28.1161 23.0799 31.3381 -0.933036 0.686599 6.01892 +7958 4 27.1717 22.9224 32.5558 0.319614 0.839726 2.26602 +7959 6 25.9992 18.4251 22.6716 -8.51512 -6.6596 14.3523 +7960 4 26.8098 18.8237 22.3895 20.3106 6.57833 -11.9809 +7961 4 25.8253 18.8771 23.5162 -1.041 -7.57666 -6.79729 +7962 6 31.1689 23.0872 29.1831 -2.26749 -18.4759 6.78914 +7963 4 31.118 22.1592 28.8841 -5.05583 5.59361 3.05947 +7964 4 31.7418 23.5345 28.5581 5.1573 7.79625 -4.49352 +7965 6 36.6391 4.9259 0.480345 37.9344 10.2065 -26.5572 +7966 4 36.638 5.82198 0.886244 0.658013 -14.6584 -5.92388 +7967 4 37.39 4.95173 41.699 -35.1456 1.42767 30.4358 +7968 6 36.484 21.0145 10.0529 -6.00883 6.48187 8.17175 +7969 4 36.4042 20.1763 9.58301 3.63574 2.58382 -3.15576 +7970 4 35.8773 20.9259 10.8015 2.14778 4.06152 -0.936887 +7971 6 50.5993 25.1947 18.3919 -28.2028 12.9956 8.35013 +7972 4 49.869 24.7394 17.9262 9.19638 1.46827 3.55355 +7973 4 51.4482 24.8993 18.0848 11.0575 -8.08323 -5.33222 +7974 6 50.1824 39.6576 12.4356 -22.7811 -7.9912 15.1349 +7975 4 49.7705 38.7879 12.6194 4.75387 11.043 -2.88475 +7976 4 51.0686 39.4751 12.1603 15.8621 -1.53988 -6.37666 +7977 6 30.5412 12.4178 4.80566 -15.3128 -2.78075 25.3711 +7978 4 30.0752 11.5776 5.01806 10.6669 11.6172 -5.90727 +7979 4 31.021 12.2424 4.01172 11.531 -8.83371 -18.4272 +7980 6 28.9525 15.4713 21.8679 -2.36978 -36.4192 26.6063 +7981 4 29.1677 14.6271 22.3934 -7.66269 33.2693 -19.6276 +7982 4 28.1632 15.8063 22.3348 7.54721 -2.84859 -11.2752 +7983 6 14.0684 9.5583 16.997 2.7235 -6.59901 -0.744295 +7984 4 14.8185 8.94582 17.0717 -0.0957791 5.7783 -3.11218 +7985 4 14.4323 10.4488 16.9992 1.00571 2.57913 -1.39277 +7986 6 4.48903 30.1743 11.858 18.777 -10.7052 13.2768 +7987 4 4.86699 29.7697 12.6847 -17.3276 7.96894 -17.1216 +7988 4 3.53137 30.2861 11.9207 -0.113543 -0.314347 4.01346 +7989 6 40.8874 8.0652 23.6541 0.993335 -18.0149 -24.6412 +7990 4 41.0014 8.23968 22.6934 -0.45004 7.6784 15.1082 +7991 4 40.7726 7.0925 23.6399 1.20374 9.92563 8.58777 +7992 6 53.7462 35.0557 16.7061 9.98011 -4.48961 -22.2856 +7993 4 53.4827 35.8182 17.2307 0.000554802 6.10184 -1.96461 +7994 4 54.0786 35.3449 15.8213 -7.68991 -0.599931 23.4559 +7995 6 53.7073 10.1889 20.3718 -10.7517 16.2467 -19.4493 +7996 4 53.8408 10.0262 19.4272 8.41512 -10.415 5.03553 +7997 4 53.1338 10.9644 20.2967 0.731263 1.06205 11.7435 +7998 6 4.58979 27.075 7.78807 17.6653 -15.6715 -1.75621 +7999 4 5.19096 26.32 7.80399 16.3727 7.79792 -3.24405 +8000 4 3.78382 26.6199 7.94519 -28.415 1.42755 3.38346 +8001 6 50.5066 22.5306 22.1436 -1.2339 18.6921 5.41009 +8002 4 50.2802 23.3104 22.6632 -2.8343 -11.09 7.6214 +8003 4 50.7991 22.9414 21.3369 4.56213 -7.53044 -15.8119 +8004 6 7.04346 27.196 21.628 9.41144 -9.96736 11.8657 +8005 4 6.8407 26.6883 22.4668 -8.25713 16.2835 -27.3312 +8006 4 6.26031 27.4748 21.116 4.26862 -9.43237 15.0117 +8007 6 23.8265 35.0499 16.5937 18.3012 9.13896 26.4348 +8008 4 24.7235 34.8381 16.9269 -14.9485 7.62278 -2.13189 +8009 4 23.7604 34.5968 15.7714 -3.77201 -11.7597 -22.7393 +8010 6 5.98953 23.8983 3.91761 -44.4181 -14.5448 -1.98234 +8011 4 5.398 23.9519 3.1318 15.794 0.401012 8.45254 +8012 4 5.35617 23.6012 4.61938 19.6174 4.72778 -5.04958 +8013 6 38.7401 25.0729 19.1247 8.8169 4.91643 10.7802 +8014 4 38.7862 24.2921 18.5681 -1.99613 -8.272 -9.94687 +8015 4 39.0639 24.8191 20.0061 -2.94522 4.87881 -4.09917 +8016 6 12.9717 18.2893 10.6182 7.92512 -8.05782 -7.58833 +8017 4 12.0999 18.3162 10.2013 -2.76008 2.25331 1.21984 +8018 4 12.8722 18.6085 11.5165 -3.68712 5.29275 10.5515 +8019 6 38.0382 41.2423 21.0873 4.88219 -19.6272 -0.152698 +8020 4 37.2014 40.7765 21.2484 2.63704 8.02432 -2.02816 +8021 4 37.8835 0.198079 20.7163 -11.2369 15.8096 -5.69312 +8022 6 6.98214 22.8682 17.8394 -5.75247 -17.9204 -1.57462 +8023 4 7.61723 23.542 17.6412 15.6839 20.0065 -5.16874 +8024 4 7.3587 22.0484 17.4826 -2.13646 0.815835 3.23256 +8025 6 24.1186 19.368 12.3177 21.0449 6.23804 -24.2445 +8026 4 23.9242 19.844 13.1293 -4.19124 -3.15082 3.8784 +8027 4 23.743 18.4928 12.3308 -10.9397 -14.908 7.07664 +8028 6 44.2213 28.4415 4.8153 2.12167 -7.44997 -5.8313 +8029 4 44.3009 28.0649 3.91739 -1.37383 9.18016 5.99771 +8030 4 44.2294 29.4128 4.74855 1.01191 -3.53144 -7.03239 +8031 6 23.3167 8.29314 21.4338 -0.329791 14.7993 14.6131 +8032 4 22.995 9.23581 21.5362 7.25813 -26.2111 -7.67418 +8033 4 23.1349 8.01865 20.5229 -2.36131 4.58949 1.23489 +8034 6 14.3464 2.19127 18.5365 1.00479 -5.05512 -1.33996 +8035 4 14.3534 1.26337 18.7781 -10.0191 -8.45544 9.17935 +8036 4 15.2531 2.29149 18.2562 13.6881 11.5937 -7.27189 +8037 6 28.0536 31.92 34.134 3.57463 -14.0429 -1.6048 +8038 4 28.4517 32.4188 34.8607 -2.66641 5.35559 -0.0232853 +8039 4 27.3246 32.4577 33.7701 8.655 -3.68096 2.2403 +8040 6 53.3502 24.7032 18.2649 -24.2711 -41.2818 -9.83264 +8041 4 53.5194 24.6019 17.3193 6.96991 8.47211 -0.102973 +8042 4 53.68 25.5059 18.6169 17.7955 37.5084 3.34479 +8043 6 36.8031 28.4187 22.9511 -10.1554 -0.61119 21.2214 +8044 4 36.5106 28.9054 23.7358 4.15696 8.73481 -5.19311 +8045 4 36.1845 27.6911 23.0035 -2.36033 -17.8474 -9.79811 +8046 6 21.8885 30.5877 27.4793 -3.11585 8.28062 7.57241 +8047 4 22.2621 31.0993 28.2061 -3.96796 1.5816 4.48491 +8048 4 22.5937 30.5949 26.8475 10.2249 -8.24374 -18.6607 +8049 6 10.2833 3.28406 27.2289 -24.5304 -2.91212 14.6365 +8050 4 10.0443 2.76427 28.0065 14.6588 -5.9106 -2.57837 +8051 4 9.44832 3.75002 27.1066 2.80489 10.142 -13.305 +8052 6 37.7147 24.9939 29.6988 5.24245 -12.5023 -10.1121 +8053 4 38.3581 24.5533 29.0689 -23.3017 1.4918 23.5498 +8054 4 37.1779 24.3214 30.1874 12.7329 5.56421 -12.5271 +8055 6 9.13611 24.4367 14.4784 20.7258 8.96054 28.4908 +8056 4 9.04651 24.998 13.735 -5.03994 20.1658 -22.0876 +8057 4 8.726 23.6299 14.2398 -14.2121 -32.2206 -7.12291 +8058 6 52.7755 31.4643 7.39569 14.5412 -1.52098 0.484013 +8059 4 52.3413 32.1584 6.88884 0.00633314 4.2069 -4.47258 +8060 4 52.0605 30.9716 7.79316 -9.34275 -9.05133 5.36325 +8061 6 21.3287 5.44475 36.4975 17.176 -11.9485 -14.2877 +8062 4 20.7483 5.50715 37.2619 4.90115 -8.53405 7.77147 +8063 4 21.912 4.64524 36.5597 -18.1029 20.6035 4.94996 +8064 6 25.1768 37.2214 4.32574 4.31983 -25.8241 -7.35849 +8065 4 25.4326 36.64 3.57657 -1.88178 18.0132 5.09494 +8066 4 24.8685 36.5657 4.9694 -1.32139 10.7309 7.78615 +8067 6 33.9928 17.4475 18.2473 -28.4515 -0.0793518 28.5349 +8068 4 34.2921 17.0113 19.1053 -15.0281 13.9289 -20.2703 +8069 4 33.1064 17.9171 18.4165 33.1367 -21.5966 1.81969 +8070 6 37.9532 37.4932 25.2939 -37.7872 -15.4269 -20.4394 +8071 4 36.979 37.7096 25.1406 34.3292 -3.43428 9.43604 +8072 4 38.1084 36.7677 24.6487 1.47089 11.2608 10.0337 +8073 6 5.08061 4.87523 15.8431 -4.86231 -7.56388 -2.23136 +8074 4 5.78156 4.1744 15.8759 -9.54967 26.0091 2.46095 +8075 4 5.43258 5.75 16.0822 6.78608 -13.538 3.56789 +8076 6 14.1628 7.20449 7.78038 25.2379 -5.46067 -13.6381 +8077 4 13.5115 7.54153 8.36471 -22.6877 11.2017 23.85 +8078 4 13.6914 6.99143 6.96374 5.13235 0.836748 0.117842 +8079 6 24.9714 10.8522 38.0874 21.7543 24.8019 24.8971 +8080 4 25.3733 11.7327 37.9223 -2.75098 -14.513 10.3213 +8081 4 24.5811 10.6456 37.27 -22.0988 -18.3607 -37.1034 +8082 6 35.6792 7.98105 22.8098 -5.63995 -0.874411 -1.68631 +8083 4 36.3111 8.66137 23.0699 5.30437 2.23481 0.770305 +8084 4 35.3824 8.20038 21.9134 0.62108 2.61089 2.3422 +8085 6 24.7967 29.145 22.4166 8.97915 1.26062 2.6062 +8086 4 24.9285 28.4017 23.0307 -7.24415 3.31799 -2.87627 +8087 4 23.8684 29.1691 22.1667 -6.93063 -5.53381 0.128782 +8088 6 38.5003 31.6402 38.4666 0.118802 17.9484 -3.06973 +8089 4 38.5639 32.3894 37.8454 -0.598215 -11.959 -0.514206 +8090 4 38.3632 32.08 39.3134 -2.43734 -3.45212 12.1107 +8091 6 7.2246 33.2558 15.4144 3.93224 14.6297 14.7993 +8092 4 8.10558 33.3578 15.8508 -19.4169 -6.69939 -13.0108 +8093 4 7.30076 32.5035 14.7978 2.24681 10.3389 8.67702 +8094 6 43.3411 23.605 1.45378 1.24542 -6.52262 6.11498 +8095 4 43.1714 24.3501 0.858367 5.1295 -5.17404 3.37123 +8096 4 44.2208 23.7695 1.84296 -12.8059 2.13297 -8.4534 +8097 6 3.53981 32.9157 14.8686 -7.67856 -8.73615 6.98201 +8098 4 3.60397 33.2061 13.9566 0.668747 6.43783 -7.96574 +8099 4 3.81902 33.649 15.4236 5.03764 7.23473 -0.501009 +8100 6 25.308 21.7722 8.24708 3.37146 -12.406 14.7751 +8101 4 26.0573 21.1741 8.36562 1.41198 8.84323 -6.65363 +8102 4 24.826 21.6647 9.09095 -1.64121 7.89428 -12.8382 +8103 6 43.814 15.3562 17.763 -19.8802 -3.64728 -7.58039 +8104 4 43.4756 15.1225 16.8733 5.20247 0.973102 4.81929 +8105 4 44.7686 15.2775 17.7045 7.07231 -2.77487 -5.74422 +8106 6 15.7867 16.2594 16.6597 40.7179 11.0003 30.8626 +8107 4 16.4245 16.8568 16.2414 -0.344326 0.180624 1.74019 +8108 4 15.1074 16.2177 16.037 -41.8412 -2.72902 -33.087 +8109 6 31.9018 12.864 11.5221 -0.527288 11.9796 -2.61342 +8110 4 32.4715 13.19 12.2739 -15.261 0.218931 -18.2329 +8111 4 31.4408 13.5947 11.0331 13.5047 -10.6099 18.0399 +8112 6 18.2179 5.3463 10.1762 9.71532 5.2148 -18.3501 +8113 4 17.8204 5.66693 9.33813 -2.6575 -7.74782 15.1878 +8114 4 17.5556 5.18411 10.851 -9.29453 0.73034 -3.17809 +8115 6 23.0812 39.0781 10.9303 2.37609 8.25457 -4.90642 +8116 4 24.0025 38.8104 10.892 -1.10831 -0.594451 2.83356 +8117 4 23.078 39.9337 10.4697 -7.78026 -4.85412 5.47405 +8118 6 46.8678 33.747 8.76655 -5.11485 44.7451 24.4631 +8119 4 46.406 34.5339 8.40734 -0.304999 -21.98 -10.152 +8120 4 47.1603 34.1422 9.62028 2.09293 -20.2864 -11.5212 +8121 6 31.2447 39.9321 20.2226 -0.330123 -0.585472 -4.98228 +8122 4 30.8504 39.3151 19.5884 6.05804 4.05585 3.92388 +8123 4 32.2053 39.9316 20.0453 -4.95864 -1.44581 -1.12159 +8124 6 15.9016 33.0949 19.7876 25.1907 -5.52815 -22.1207 +8125 4 16.0748 33.7133 19.0349 -1.92202 -14.988 11.1016 +8126 4 16.5267 32.3265 19.6592 -15.8695 19.8556 5.2806 +8127 6 32.5654 39.9188 2.66304 17.6014 -10.2623 -15.3377 +8128 4 33.3417 39.59 3.14903 -11.9816 5.68487 0.865723 +8129 4 31.9971 40.348 3.29791 -5.42947 4.08066 9.69521 +8130 6 50.71 12.2088 3.91621 6.45352 -28.1924 -19.9843 +8131 4 51.4315 12.4725 3.33505 0.00989865 5.72461 1.55844 +8132 4 50.5782 12.8645 4.57223 -0.528152 29.464 22.8196 +8133 6 44.6954 2.75762 12.1022 0.941183 0.541095 5.21442 +8134 4 45.0772 1.91827 11.8337 7.97486 -4.13832 -5.1586 +8135 4 44.7961 2.76556 13.0748 -3.12194 1.26681 -13.8655 +8136 6 11.5119 11.9446 31.6555 0.0165034 5.87533 16.9496 +8137 4 11.2786 12.7291 32.193 1.1093 -4.42098 -1.85793 +8138 4 11.5615 11.2089 32.2952 3.49417 6.36211 -10.0029 +8139 6 4.75553 10.0442 10.5026 -0.613356 7.28818 -1.41717 +8140 4 5.04922 10.2458 11.3982 -0.190174 3.033 -2.19553 +8141 4 4.45357 10.8768 10.0827 4.22944 -8.29703 6.91569 +8142 6 17.1004 25.0221 20.585 20.8628 27.7333 -27.8469 +8143 4 16.2314 24.7196 20.7848 -24.892 -11.5638 6.73224 +8144 4 16.9745 25.5771 19.7683 4.93088 -15.3222 19.1034 +8145 6 48.1032 4.75801 14.8026 37.7024 -16.8658 7.41777 +8146 4 47.1817 4.923 14.9438 -21.3904 13.2232 -6.86149 +8147 4 48.4894 5.33532 14.1187 -17.354 1.23192 4.40994 +8148 6 18.8584 3.1094 3.41532 -17.9645 -5.092 -5.76247 +8149 4 18.4858 2.24853 3.65522 2.22195 0.198645 3.24183 +8150 4 19.7914 2.99202 3.55078 21.8001 -2.9136 1.99579 +8151 6 35.4214 26.4496 29.0479 -25.0869 -13.2406 8.30382 +8152 4 35.4596 27.2122 28.4766 3.66886 10.9927 -9.48044 +8153 4 36.2884 26.0622 29.0901 17.6032 -4.12101 -3.28535 +8154 6 32.3918 31.2203 12.8386 46.3164 14.9485 -1.56764 +8155 4 31.5927 31.2548 13.3118 -34.7781 -0.694705 18.2501 +8156 4 32.2274 30.836 11.9945 -8.46486 -12.2685 -25.2096 +8157 6 32.9972 28.3347 37.5978 -19.2694 -14.478 20.0019 +8158 4 32.1604 27.8545 37.87 25.9433 12.8245 -4.2723 +8159 4 33.4478 28.5699 38.4425 -10.0504 -3.89776 -17.7975 +8160 6 45.4943 24.785 10.3174 -24.9891 51.3938 13.5053 +8161 4 44.9436 25.3819 9.72852 18.6998 -28.2383 15.0369 +8162 4 45.6946 23.9769 9.88803 3.95472 -26.3164 -24.236 +8163 6 14.7646 31.7016 3.17106 -12.494 -4.77828 16.8956 +8164 4 14.1278 32.382 2.84257 8.55448 -13.727 9.9815 +8165 4 14.4774 31.2925 4.03575 0.781246 20.1514 -26.73 +8166 6 31.932 7.70259 4.29822 28.2629 -13.9597 32.9447 +8167 4 31.5142 6.8338 4.23667 -1.26054 0.464616 -4.26218 +8168 4 31.5893 8.26695 3.64018 -18.9284 22.0156 -31.588 +8169 6 42.5661 17.3076 32.2072 4.58091 20.9841 -12.8778 +8170 4 41.6153 17.2751 32.1225 -13.9289 -9.63208 0.974916 +8171 4 42.7549 18.1312 31.7017 7.23855 -15.1499 9.29454 +8172 6 13.801 23.1802 23.5544 20.5107 -9.18639 9.43365 +8173 4 13.5559 23.799 24.2431 -7.02941 8.57916 4.58982 +8174 4 14.6139 22.757 23.9348 -15.8084 7.21572 -12.2969 +8175 6 10.7224 7.09218 3.96878 16.2046 -14.1912 -58.7694 +8176 4 10.4615 7.01435 4.86228 -13.7845 -9.22242 34.898 +8177 4 10.4899 6.25858 3.45399 4.94204 24.1379 24.5516 +8178 6 28.7975 8.66057 17.8838 -26.4281 5.00156 -27.4828 +8179 4 29.5466 8.31163 17.3909 5.91048 -3.96826 -5.96201 +8180 4 28.1517 8.96764 17.1731 20.0585 -9.38402 22.2692 +8181 6 19.4445 29.3512 26.6402 -27.7559 12.8002 37.2849 +8182 4 18.9931 29.7086 27.4672 16.1765 -10.1498 -30.4371 +8183 4 20.3292 29.7071 26.6996 8.86807 3.45557 2.67965 +8184 6 40.676 40.9989 14.5783 -1.81287 -10.2023 17.4849 +8185 4 40.8703 41.6798 13.9303 10.8761 5.87921 -5.34291 +8186 4 41.4788 40.6754 15.0317 -0.103076 9.61372 -9.63617 +8187 6 46.2568 14.0853 31.7234 10.6503 -1.46249 4.93376 +8188 4 46.4506 13.1375 31.7184 -3.79774 3.42444 -0.601084 +8189 4 45.5065 14.2191 31.1522 -8.96365 0.976246 -7.34606 +8190 6 36.7103 36.3065 8.39844 -19.1971 -27.2559 -17.1971 +8191 4 36.3822 37.2167 8.51449 20.2374 -9.10083 14.9839 +8192 4 37.462 36.0245 8.9597 -8.83948 23.9771 2.75809 +8193 6 30.7983 32.4219 38.0908 -28.9564 1.76229 18.7871 +8194 4 31.3387 31.9445 37.476 23.2205 -2.83162 -11.1976 +8195 4 31.2894 33.1287 38.5298 9.85106 -3.61838 -6.87003 +8196 6 47.9 8.84746 10.1809 13.9026 13.2481 4.99334 +8197 4 47.2314 9.07534 9.54683 -14.9306 19.0332 -8.73943 +8198 4 48.008 7.93273 10.003 10.2061 -26.7512 4.08493 +8199 6 24.4282 17.0027 30.9766 -8.14946 0.47403 -13.61 +8200 4 23.7021 16.9118 30.3187 14.132 0.581257 9.28124 +8201 4 24.0019 17.1514 31.8341 1.66288 -1.35228 -5.87998 +8202 6 40.5039 5.09263 4.48513 -8.56504 -6.5373 -32.2613 +8203 4 41.2755 5.64065 4.37578 16.2932 9.35997 9.97847 +8204 4 40.1843 5.0523 3.55179 -2.89742 -7.45623 19.6864 +8205 6 52.5794 28.086 6.91602 -27.2154 -20.1235 6.97783 +8206 4 52.4353 28.6007 6.11552 3.94928 -0.112987 0.705634 +8207 4 51.6969 27.6552 7.08025 27.1089 14.7333 -4.60736 +8208 6 36.0629 32.381 23.6142 9.17579 -16.9148 -2.4755 +8209 4 36.5407 32.2813 22.7776 -1.15674 3.38979 7.41153 +8210 4 35.7113 33.2654 23.6252 -9.15386 11.2493 0.0331211 +8211 6 23.6552 31.8756 22.7565 -25.0136 1.00336 21.6204 +8212 4 23.73 32.5959 22.1297 15.1034 -2.64982 -11.1407 +8213 4 24.3343 31.2055 22.6866 12.2933 -0.39941 -10.0267 +8214 6 0.736598 24.4641 41.7072 -6.94393 1.55048 -19.4095 +8215 4 1.23654 24.8288 40.9522 -3.95743 -2.80997 9.51773 +8216 4 54.8325 24.2702 41.3637 13.4109 4.08216 3.5339 +8217 6 15.9721 8.97822 19.8125 19.0517 -22.613 16.6544 +8218 4 15.5497 8.29105 19.3091 -4.28185 -9.24838 -10.3339 +8219 4 15.6128 9.78815 19.5092 -16.7051 35.4763 -13.493 +8220 6 33.1656 12.5735 20.0353 32.8597 -32.3881 -24.7893 +8221 4 32.9817 11.6196 19.8453 -6.04217 28.6875 8.28399 +8222 4 34.1172 12.6638 19.7368 -32.1809 10.6792 11.3696 +8223 6 7.04894 24.9401 26.3957 -12.3425 -2.00741 -5.21086 +8224 4 6.75821 24.2907 27.0478 8.01299 -1.99342 6.24335 +8225 4 7.89161 25.3154 26.6505 10.7219 -3.29246 12.7441 +8226 6 44.479 22.5508 36.9163 -6.8399 -5.44184 13.3083 +8227 4 43.5214 22.4098 37.071 12.5044 3.3732 -3.51472 +8228 4 44.595 22.7899 36.0028 -4.86816 3.42784 -13.6235 +8229 6 39.2745 23.7032 25.1197 -32.3737 -81.7274 9.17932 +8230 4 39.5886 24.5492 24.9992 24.471 68.8814 -13.2187 +8231 4 38.7456 23.4691 24.3377 5.22396 6.33701 6.85867 +8232 6 20.3646 2.19602 36.9892 -4.85825 6.83938 3.69158 +8233 4 20.3067 1.45038 37.5971 1.4243 -8.23943 -2.36696 +8234 4 20.3942 1.88275 36.0861 3.42557 -6.35335 -2.19064 +8235 6 22.8664 19.5513 3.67104 -13.2265 5.28042 31.2857 +8236 4 22.7633 19.8561 4.6286 7.01101 -9.22167 -32.7463 +8237 4 23.7764 19.7315 3.39612 4.00916 2.85623 5.02623 +8238 6 31.705 12.5768 34.6039 18.8969 7.7197 42.0834 +8239 4 31.1026 13.3107 34.9476 21.2302 -23.3848 -5.30166 +8240 4 32.3569 12.3026 35.3493 -33.8624 17.1964 -33.567 +8241 6 12.9851 10.2105 25.0956 -25.1193 26.0078 -38.429 +8242 4 13.6149 10.0452 25.7619 22.39 -15.9831 32.7066 +8243 4 12.4963 9.40655 24.9468 1.34194 -14.9569 1.62555 +8244 6 27.2621 0.584423 13.2176 -28.6404 -16.2485 2.71576 +8245 4 27.7069 41.6292 13.1518 2.13728 8.59646 -2.51953 +8246 4 26.2847 0.395264 13.1771 23.0038 6.72582 -0.601928 +8247 6 5.66006 24.9398 13.9833 -7.43295 9.91556 10.5591 +8248 4 4.70147 24.9177 13.9802 -4.26929 -7.73667 -8.07402 +8249 4 5.82197 25.381 14.8221 8.41297 -1.15026 -0.763214 +8250 6 22.9908 17.9523 0.521723 7.02411 -25.4698 12.909 +8251 4 22.4592 18.6506 0.142784 -9.22706 3.46645 -2.83539 +8252 4 22.3527 17.3052 0.930771 13.2695 22.3169 -13.3733 +8253 6 33.0935 25.4243 5.46557 -9.38497 -10.8046 -8.60877 +8254 4 33.4966 26.2756 5.44764 14.9521 17.8538 5.01915 +8255 4 32.9941 25.2035 4.5344 -2.6207 -6.96629 2.5324 +8256 6 8.53079 7.95552 17.4804 7.64086 6.41223 -26.4035 +8257 4 9.4001 8.35547 17.2638 -9.73917 -4.33322 7.64386 +8258 4 8.4487 7.94255 18.4286 4.30191 2.70426 16.6029 +8259 6 26.8371 0.685906 2.89773 -0.256761 31.01 4.86999 +8260 4 26.7806 0.433187 3.83156 0.637082 -2.67537 2.60738 +8261 4 26.6279 1.66343 2.89109 6.9325 -26.481 -2.08778 +8262 6 50.0417 34.7142 15.6334 -23.0288 8.72534 -30.9996 +8263 4 50.5531 35.2159 14.9759 6.02412 -4.51102 12.1494 +8264 4 49.1615 34.6714 15.1751 14.0914 -5.62478 19.352 +8265 6 46.2791 4.99946 11.1196 9.7179 12.4772 -7.72995 +8266 4 45.7827 4.25534 11.4529 -10.6417 -11.5364 6.26713 +8267 4 46.9456 4.6214 10.5389 1.00953 -4.68959 -1.2994 +8268 6 33.7936 38.6123 35.3918 15.2762 25.882 47.4359 +8269 4 34.0305 39.0866 36.2411 -6.18084 -28.1229 -24.2145 +8270 4 33.6134 39.3784 34.8506 -5.42867 -1.33428 -20.4371 +8271 6 30.8282 25.8371 41.2172 -7.09757 -19.9215 -22.3179 +8272 4 31.1427 24.9253 41.375 1.19635 8.28989 4.89631 +8273 4 31.1138 26.3841 0.0263053 10.2845 10.2166 22.0109 +8274 6 50.2275 0.982033 24.4751 51.8832 -7.79127 14.7425 +8275 4 49.5671 0.561213 23.9746 -37.5145 -10.5742 -20.1648 +8276 4 51.0349 0.46072 24.2534 -17.6876 18.8276 11.0022 +8277 6 31.2908 0.710797 19.047 -2.09434 13.573 -1.22083 +8278 4 30.4487 0.672221 18.611 -14.5784 9.11804 -11.7691 +8279 4 31.2841 41.7946 19.4765 8.98672 -35.4229 20.9418 +8280 6 39.0741 29.5515 19.1276 -25.3595 -21.9961 15.137 +8281 4 38.1807 29.4949 19.565 25.109 7.94863 -12.7917 +8282 4 39.4837 28.6866 19.3452 2.49072 15.8212 -6.56848 +8283 6 21.6546 17.5955 25.8962 -6.78298 15.7545 0.118362 +8284 4 22.0482 18.4938 26.0891 -15.3421 -24.4294 -5.96834 +8285 4 20.8112 17.7106 25.4012 18.8301 2.25602 6.45745 +8286 6 35.0761 28.7988 27.4227 3.11164 -5.22767 30.3338 +8287 4 35.4099 29.4705 28.0422 -1.31539 -7.25274 0.820077 +8288 4 35.176 29.229 26.5925 2.58985 10.308 -31.8228 +8289 6 30.7102 25.4463 11.6589 -5.09223 14.513 32.8165 +8290 4 30.6059 25.8179 12.6014 3.72506 -14.6402 -39.0718 +8291 4 30.6061 26.1982 11.055 2.14208 -0.820709 7.44645 +8292 6 7.34821 15.124 12.3469 -7.98455 -28.7648 8.02815 +8293 4 6.65824 14.4547 12.1585 7.38491 7.52419 4.72727 +8294 4 7.19665 15.7511 11.658 -2.78105 24.4343 -15.0907 +8295 6 16.8417 26.815 7.05419 -24.774 6.28148 -21.5195 +8296 4 17.6138 26.5995 7.5418 30.7131 -10.23 16.3776 +8297 4 17.1302 26.9688 6.14022 -2.93816 -3.28182 4.8763 +8298 6 29.5112 33.0571 30.9901 -17.2684 21.8413 -16.809 +8299 4 28.6007 32.8494 30.6893 8.91061 -10.9491 6.08618 +8300 4 29.8939 32.355 31.5124 -6.62171 -19.0922 5.25725 +8301 6 14.1054 2.12143 30.9174 -7.90077 -11.4283 37.211 +8302 4 14.0041 2.00138 31.9209 0.0297695 4.78336 -39.0496 +8303 4 13.7376 1.30679 30.5176 6.48361 9.45743 4.44265 +8304 6 15.6593 22.2688 2.88796 -26.3773 12.8308 -8.6958 +8305 4 16.4059 21.7286 3.01985 35.1738 -16.1657 6.55343 +8306 4 15.0005 21.6175 2.62854 -10.183 2.33344 0.69621 +8307 6 23.7324 29.1178 40.9691 12.375 28.71 1.88761 +8308 4 23.2563 30.0016 40.9795 15.1309 -27.3218 0.73938 +8309 4 24.7153 29.2815 40.9372 -24.8849 -3.40565 0.339466 +8310 6 38.1289 14.1609 13.7163 11.3988 23.3452 4.961 +8311 4 37.6355 13.3641 13.8052 -15.0683 -25.2976 3.04519 +8312 4 38.877 13.9408 13.1592 7.07353 -0.711776 -7.39216 +8313 6 35.2564 26.5047 15.5196 1.21661 4.3606 12.6683 +8314 4 34.5556 26.4436 14.8616 -0.145442 -0.409522 -0.299569 +8315 4 34.9009 27.0522 16.256 4.1263 -8.75979 -17.8666 +8316 6 19.0944 34.7315 16.477 3.93496 0.874554 38.8769 +8317 4 19.5342 35.6013 16.5498 -2.87948 -9.96323 -9.99674 +8318 4 19.0181 34.4301 15.5899 3.71142 3.01681 -30.4069 +8319 6 18.1805 29.7449 35.7046 18.8444 17.1873 -3.97052 +8320 4 18.2235 30.6593 35.335 -4.4784 -20.2666 13.1463 +8321 4 19.056 29.5886 36.1261 -9.76671 1.23141 -6.47371 +8322 6 54.1188 22.2659 24.9096 4.78421 -24.6774 -19.3149 +8323 4 53.6441 21.8104 24.1769 10.121 5.11789 9.9801 +8324 4 53.5075 22.9378 25.1661 -14.3198 20.1313 5.7187 +8325 6 30.3323 10.3375 34.0061 7.35563 0.641124 -2.21855 +8326 4 29.5734 10.4043 34.5817 -14.4555 0.0376959 9.72957 +8327 4 30.8213 11.1653 34.1487 -3.17747 -4.67635 -0.590304 +8328 6 38.3211 33.8974 18.5888 -1.32754 -0.89807 -0.720993 +8329 4 38.9926 33.271 18.8539 2.22312 -19.1913 3.89796 +8330 4 38.8713 34.6655 18.5317 3.84957 24.8056 -1.31283 +8331 6 22.4809 14.1697 34.431 -22.1622 -5.27184 -37.8541 +8332 4 22.5433 13.5186 33.673 0.822047 20.8222 24.5167 +8333 4 23.1773 14.0067 35.0533 16.0768 -5.18569 10.3575 +8334 6 38.0141 0.622036 2.34694 9.03481 -5.1652 10.3599 +8335 4 37.7113 1.09641 3.1189 -18.3016 16.1314 2.00329 +8336 4 38.7028 0.120019 2.79986 6.1006 -11.8827 -16.4842 +8337 6 38.8847 41.1446 10.3004 16.8495 57.0142 -12.497 +8338 4 38.6453 0.212884 10.3117 6.47193 -33.8599 -1.337 +8339 4 38.2374 40.7573 10.8541 -26.8649 -17.5582 22.9746 +8340 6 53.4109 21.9211 38.9712 27.3607 0.0645619 -10.5759 +8341 4 53.0384 21.9801 38.0859 -10.7304 2.2749 -0.0111998 +8342 4 54.3668 22.0571 38.7395 -19.1981 -5.88632 12.9741 +8343 6 39.9872 12.7205 36.288 -8.06793 35.3321 20.4333 +8344 4 39.087 12.3834 36.3725 1.18883 -9.13664 -3.11406 +8345 4 40.4905 12.1818 35.7009 7.36107 -20.124 -19.0601 +8346 6 48.4463 17.2389 40.5967 -24.7278 4.81563 12.4078 +8347 4 47.5665 17.6971 40.4852 25.7833 -12.0744 1.257 +8348 4 48.3987 16.886 41.5134 6.10343 4.05346 -12.6042 +8349 6 32.0413 9.35688 40.0251 1.84943 -9.41379 10.5137 +8350 4 32.8011 9.3156 39.4233 -4.71533 -3.42986 0.347912 +8351 4 31.8082 8.43016 40.2864 3.98001 20.4877 -6.20043 +8352 6 31.7351 22.4909 6.36481 -11.9835 4.517 5.86255 +8353 4 31.4453 21.6589 6.79738 2.31245 15.2673 -2.59345 +8354 4 31.3521 23.2372 6.88711 4.39127 -22.2776 -7.77946 +8355 6 51.0252 2.58567 21.5888 12.0252 -3.79771 4.1956 +8356 4 51.3852 1.69652 21.8042 -1.91984 13.1306 -1.09782 +8357 4 51.7712 3.19849 21.4753 -6.25067 -9.48202 2.92476 +8358 6 13.6387 22.0486 12.1519 25.289 13.6281 9.24284 +8359 4 14.4553 22.4795 12.4841 -9.12946 -7.35477 -7.44936 +8360 4 12.9422 22.6971 12.3091 -5.69931 -0.254566 -0.690626 +8361 6 23.6098 24.0343 14.6404 -2.85842 21.3712 -30.1324 +8362 4 24.3054 24.4792 15.1401 1.72137 -5.65962 3.08819 +8363 4 23.5196 24.6041 13.8393 -4.42688 -17.9982 21.1692 +8364 6 9.32217 4.85318 31.2328 11.4746 -4.61869 -4.10735 +8365 4 8.43042 4.86168 30.8848 -9.06213 4.49291 -0.279243 +8366 4 9.25495 5.26013 32.106 -3.85952 -1.36 2.0258 +8367 6 16.6786 26.3118 18.041 -30.5179 5.83101 -14.1852 +8368 4 15.8205 26.6594 17.6987 9.23568 -14.6779 7.38956 +8369 4 17.2149 27.0871 17.9121 20.6972 11.6613 1.32787 +8370 6 5.1068 13.5155 11.5503 -9.62018 18.629 -29.2057 +8371 4 4.37741 13.3629 12.1623 -7.62379 -0.222526 0.540006 +8372 4 4.70689 13.979 10.7366 10.5209 -18.4088 37.9064 +8373 6 29.6181 23.6359 8.06142 -1.81854 7.21422 -1.70755 +8374 4 29.1888 23.4521 8.90141 0.206013 -3.23773 -0.0922606 +8375 4 29.4815 24.5976 7.98987 7.61073 -10.2969 -5.72522 +8376 6 0.801466 7.54671 27.8401 6.5354 -3.49578 -14.7683 +8377 4 0.895859 7.27352 28.7573 1.78004 -0.979843 7.25552 +8378 4 1.54585 8.15528 27.6648 -11.1939 -10.5496 5.25649 +8379 6 15.4336 9.77253 0.489553 0.922542 4.3707 -1.35473 +8380 4 16.0351 9.34865 41.7726 4.14277 -6.55565 2.56274 +8381 4 15.4857 9.31476 1.34042 4.74784 -1.15717 -0.337147 +8382 6 18.8008 0.0730809 34.105 -10.3773 -6.96418 -21.8764 +8383 4 18.5081 41.5423 33.2731 5.22569 12.9238 15.5106 +8384 4 18.5071 0.998566 34.0742 -2.68781 1.40869 -5.2752 +8385 6 18.7326 30.7673 29.1559 48.9948 -22.8293 28.8452 +8386 4 19.5421 30.7479 29.7792 -35.6741 -9.01286 -31.0748 +8387 4 18.496 31.6741 29.187 -17.0068 24.787 -0.45657 +8388 6 48.459 16.4997 36.139 1.45519 10.5028 1.01521 +8389 4 47.6111 16.9857 36.2164 10.4415 -5.87096 -2.55811 +8390 4 48.4968 16.1176 35.2432 -2.18798 4.21486 5.30298 +8391 6 43.8007 0.467658 29.2569 28.3678 -13.8677 -3.77703 +8392 4 42.8971 0.305725 29.4937 -25.3214 -1.14832 5.94808 +8393 4 44.2622 41.5592 29.5347 -3.4854 12.8866 -0.12306 +8394 6 16.7282 13.8764 21.3804 -5.85841 5.25102 8.86173 +8395 4 16.2274 14.7005 21.5266 6.94274 -6.60805 -7.01164 +8396 4 16.607 13.4327 22.2267 1.29648 -4.09529 1.45702 +8397 6 17.3848 13.434 26.2514 27.8708 0.579352 -19.8612 +8398 4 18.2073 13.6243 25.7048 -28.5107 -7.2193 21.7409 +8399 4 17.5944 12.6077 26.718 -2.1357 3.12496 0.608863 +8400 6 48.1647 10.2208 23.7049 7.80266 -18.7522 13.388 +8401 4 47.9825 10.5204 24.6118 -3.05612 1.76991 -8.97221 +8402 4 48.0139 10.9468 23.1026 -1.19683 7.34816 1.26356 +8403 6 28.2773 17.9142 17.8758 3.72989 18.9709 -15.182 +8404 4 29.0682 18.432 17.6259 -4.1904 -8.84834 4.2635 +8405 4 28.5441 17.0749 18.25 8.7895 -11.8779 5.35139 +8406 6 54.0848 38.1774 23.6862 8.79068 2.20397 4.23058 +8407 4 0.0366427 38.003 23.4974 -14.1536 0.885634 -1.20583 +8408 4 53.5245 37.5494 23.203 6.54807 -0.952262 -0.611804 +8409 6 8.48984 18.3998 11.4055 -13.462 -3.57414 27.789 +8410 4 7.65602 18.6961 11.043 -9.38292 3.75479 -0.915161 +8411 4 9.09748 18.5243 10.712 30.3826 3.02886 -30.4498 +8412 6 45.9441 12.8818 11.0222 -16.4049 1.91652 -6.40765 +8413 4 46.711 12.6299 10.4835 -7.54952 -0.564906 -6.57768 +8414 4 45.1235 12.7466 10.4771 21.7466 0.735613 7.10643 +8415 6 16.2215 8.79448 14.033 27.9098 -14.9816 6.01142 +8416 4 15.5522 9.3752 13.7952 -53.829 20.9905 -11.5495 +8417 4 16.9359 9.40542 13.9326 31.9466 3.3348 3.59486 +8418 6 42.7223 13.3863 21.3918 29.8224 16.7773 6.64199 +8419 4 41.9142 12.8874 21.2836 -9.67718 -3.29752 -8.9243 +8420 4 42.6271 14.312 21.0975 -16.0363 -11.184 0.152454 +8421 6 20.9977 40.4228 16.4707 19.2311 -21.9074 5.84064 +8422 4 20.7341 40.0536 17.3362 -0.495629 5.04161 -8.05599 +8423 4 21.8212 39.937 16.2081 -24.2166 11.8961 5.45251 +8424 6 45.6397 11.4296 32.9439 38.4109 -29.1814 -9.99274 +8425 4 46.3321 10.7493 33.2028 -28.4056 24.9384 -5.22126 +8426 4 45.113 11.6624 33.7013 -7.79747 1.97566 18.4384 +8427 6 26.9602 8.8599 24.2968 13.5915 2.79356 4.8338 +8428 4 27.3951 9.75608 24.2837 -6.20264 -27.5971 5.81865 +8429 4 27.4821 8.2415 24.8764 -5.62896 20.549 -11.158 +8430 6 18.9707 2.44141 29.3655 -2.01209 17.0873 0.653095 +8431 4 18.2519 2.38593 30.0124 -1.45633 -1.83702 1.76482 +8432 4 19.0982 3.39915 29.1871 -0.208097 -9.69202 4.76181 +8433 6 8.2396 29.1642 19.724 -7.67611 -9.48635 17.3168 +8434 4 8.16332 28.9052 20.6672 2.00381 4.74558 -18.2193 +8435 4 7.79264 28.4685 19.2154 1.97612 2.42161 3.19163 +8436 6 9.03293 34.3085 18.6392 -6.8245 -3.51508 -5.57673 +8437 4 8.73043 34.3576 19.5508 2.61936 3.47829 -5.40237 +8438 4 9.19173 35.2194 18.3614 3.83285 -0.179546 -0.301582 +8439 6 10.1806 11.9309 11.2378 5.33181 -8.21116 5.18339 +8440 4 10.4199 12.8404 10.9987 -8.38943 -3.43734 -3.26379 +8441 4 9.2213 11.8063 11.1618 4.16708 15.3888 -2.40164 +8442 6 35.7388 21.6853 36.1571 -21.2187 21.2566 3.59668 +8443 4 35.0074 22.3505 36.1843 15.9506 -16.0405 0.715421 +8444 4 36.3839 21.978 36.8321 -7.05156 -5.2756 -8.86951 +8445 6 17.0774 12.5078 36.39 -5.14261 15.8003 12.7424 +8446 4 17.3404 12.7479 37.2961 -4.35419 -1.09545 -7.6232 +8447 4 17.4977 11.6659 36.234 4.71638 -15.3379 -7.50181 +8448 6 37.1607 13.034 34.2837 0.889917 6.85814 -56.1323 +8449 4 36.6144 12.2451 34.135 3.16712 2.80772 8.73621 +8450 4 37.2953 13.1592 35.1962 -1.91867 -3.10361 40.6259 +8451 6 38.9747 29.5563 13.2253 1.18838 24.1885 -12.4362 +8452 4 38.8174 28.6959 12.8484 -2.87796 -16.626 0.178868 +8453 4 38.7606 29.548 14.1582 -0.666122 -3.30753 9.89159 +8454 6 0.17037 29.343 29.4884 -1.26324 3.91124 -27.2421 +8455 4 0.785297 28.6867 29.1327 1.78511 -2.78426 6.40223 +8456 4 54.9717 29.8735 28.6813 -2.47422 -4.8209 18.3172 +8457 6 15.9286 0.264913 12.7638 2.77369 8.97324 -0.606717 +8458 4 15.3998 0.564835 11.9867 -4.35739 -9.72902 15.1241 +8459 4 15.3918 41.7399 13.4663 -4.26125 7.58409 -15.055 +8460 6 3.98508 11.9472 8.79546 -10.0423 -23.9471 10.8905 +8461 4 4.30821 11.7435 7.92681 6.40121 -7.70989 -16.6116 +8462 4 3.96465 12.8834 8.77069 -2.75643 37.1798 9.03734 +8463 6 24.0517 23.6768 19.9772 9.9875 -0.396554 0.578582 +8464 4 23.5025 22.9354 19.7663 -8.47693 -16.0962 -5.40355 +8465 4 23.4442 24.2751 20.4024 2.14545 13.6845 6.88162 +8466 6 4.48152 2.30986 23.9923 -27.0109 23.4084 27.373 +8467 4 4.59263 2.40669 23.0716 9.73085 -3.6317 -36.525 +8468 4 3.6479 2.81506 24.1139 10.3345 -10.6947 10.8816 +8469 6 33.0856 27.6588 33.8383 -8.68317 -6.77689 0.893276 +8470 4 33.3543 28.5605 33.6822 -2.66039 14.7626 -6.22211 +8471 4 33.7694 27.2718 34.3804 4.93538 -5.90298 8.33006 +8472 6 11.4012 21.7076 6.08442 -20.9181 -7.28975 6.20623 +8473 4 12.3452 21.6439 6.06884 23.6791 -0.506282 -5.12853 +8474 4 11.1369 22.1078 5.25059 3.06155 -0.534748 -3.52863 +8475 6 37.2275 13.5312 23.6107 -13.7454 14.8127 9.96245 +8476 4 37.2011 14.0176 24.4689 -4.04457 -8.03454 -15.7104 +8477 4 38.0738 13.1109 23.5305 19.2281 -7.80113 -1.86698 +8478 6 5.00929 21.0475 33.3676 1.03993 27.0325 -33.9401 +8479 4 4.24931 21.2691 32.771 13.0002 -8.94008 10.7478 +8480 4 4.70945 20.492 34.0664 -10.4226 -16.4153 18.9759 +8481 6 18.2024 37.5737 26.9347 11.0126 -1.54132 -8.69207 +8482 4 17.8515 38.4557 27.1129 2.92195 -1.85995 -3.39903 +8483 4 18.9058 37.6892 26.2602 -8.80934 -3.84756 9.96821 +8484 6 19.7475 16.1502 4.67922 -0.59461 -5.69737 6.80756 +8485 4 18.938 15.9829 5.17999 -0.503733 6.42822 -3.53139 +8486 4 20.452 15.899 5.29485 1.51569 2.54074 -3.7554 +8487 6 54.0588 32.502 15.5791 2.11509 -30.3723 -27.0265 +8488 4 54.9193 32.2734 15.944 -2.03587 2.87368 2.60187 +8489 4 53.7148 33.1889 16.1175 -9.21817 24.1266 16.9863 +8490 6 31.1319 3.81908 36.7331 -8.52453 -12.3767 5.98224 +8491 4 31.0251 4.01663 37.6709 2.24281 6.85123 1.97341 +8492 4 30.7371 2.93942 36.6325 4.48759 4.53933 -4.77061 +8493 6 11.8397 14.3559 5.95013 17.712 13.5011 32.6048 +8494 4 11.8882 13.4483 5.64785 3.21485 -4.29204 1.16864 +8495 4 12.4103 14.428 6.79608 -23.3682 -9.2254 -38.5841 +8496 6 30.4732 33.6903 6.46877 -20.5926 30.9984 10.0988 +8497 4 30.0823 33.146 7.15741 -0.571027 -8.82817 5.88036 +8498 4 31.0368 33.1406 5.95739 18.3645 -25.6031 -16.3825 +8499 6 12.7874 0.539502 21.6719 -8.5062 -5.44338 -19.1545 +8500 4 12.0427 0.939271 21.1459 16.6961 -1.79193 22.1421 +8501 4 12.8959 0.982969 22.5241 -5.23507 7.86641 1.50036 +8502 6 52.7588 7.2218 26.198 16.8025 28.3515 6.33153 +8503 4 53.4065 7.96379 26.3423 -21.978 -17.2249 -4.05545 +8504 4 53.0631 6.80021 25.3976 -2.37526 -6.61619 -6.13258 +8505 6 39.7335 40.8867 3.73325 7.25622 8.93714 -16.4459 +8506 4 39.3445 40.0379 3.8542 -7.03998 -23.1188 -2.87281 +8507 4 39.6833 41.2661 4.59764 3.93702 15.0893 17.324 +8508 6 20.121 31.9222 21.9838 -6.71526 -6.20654 6.86321 +8509 4 19.4522 31.9772 22.708 13.7594 -4.46219 -12.9776 +8510 4 20.3423 32.8279 21.7497 1.41177 8.86705 -0.575134 +8511 6 12.8675 35.0031 4.45346 44.828 -17.7313 4.60062 +8512 4 12.2237 35.6716 4.40701 -39.658 29.9319 -2.18346 +8513 4 13.7076 35.4677 4.24983 -7.53722 -6.26381 -0.0905995 +8514 6 24.0625 33.6591 24.8433 7.47563 8.71661 -6.22666 +8515 4 23.7256 32.9086 24.3593 -5.011 -9.84395 -6.229 +8516 4 24.8651 33.8891 24.3525 -1.08488 0.504411 0.449776 +8517 6 40.1566 40.8925 22.745 3.65995 -18.1772 23.084 +8518 4 39.459 41.1173 22.1514 -10.4135 8.7075 -19.9273 +8519 4 39.655 40.5713 23.5068 11.7186 -0.819555 2.88668 +8520 6 15.5608 2.83174 38.4548 -17.961 4.93292 18.3513 +8521 4 14.8017 3.44348 38.6509 23.1729 -8.01231 -13.692 +8522 4 16.317 3.27039 38.0376 1.48109 9.53369 -0.90723 +8523 6 41.0116 9.17543 16.9495 15.4695 -4.08523 -13.4682 +8524 4 41.9148 8.77619 16.8957 -14.8555 5.86712 4.74383 +8525 4 40.5932 8.80873 17.73 -3.00249 -3.47282 8.63794 +8526 6 43.1871 41.3934 9.57744 -8.69666 -18.4537 3.1119 +8527 4 42.3844 40.9156 9.26306 10.8189 9.37287 1.53096 +8528 4 43.2581 0.273962 9.04681 -5.03874 9.79533 -5.6553 +8529 6 24.9044 37.9223 30.7828 -39.5154 -3.84946 22.9815 +8530 4 23.9949 37.8093 31.2426 42.0603 4.56965 -20.1335 +8531 4 24.7148 38.3736 29.9542 -2.24489 2.04808 -5.58176 +8532 6 2.22015 5.33054 16.4399 10.309 -8.52293 4.98471 +8533 4 1.84892 4.56193 16.8809 -9.36945 -1.25887 4.31387 +8534 4 3.13742 5.05729 16.2666 0.349453 6.20437 -4.74718 +8535 6 1.39717 14.946 19.1428 25.1228 15.6369 3.14315 +8536 4 0.624759 14.5201 18.7755 -11.3456 -6.79531 3.66607 +8537 4 1.29195 14.9418 20.1112 -7.64559 -2.97115 -5.19376 +8538 6 34.323 26.551 23.7054 -6.89575 15.1076 -7.90432 +8539 4 33.5377 26.6273 23.1515 0.482254 10.7241 -2.26295 +8540 4 34.2298 25.6735 24.0419 5.3831 -21.6418 13.1607 +8541 6 41.9187 21.8289 37.5387 -12.5221 18.6557 -0.654717 +8542 4 42.0641 21.2774 38.3263 -4.73604 7.9145 -4.0056 +8543 4 41.3184 22.5612 37.831 11.9642 -17.2916 1.51119 +8544 6 39.4187 37.6728 12.6286 4.8532 5.57593 -2.65087 +8545 4 38.7905 38.0203 13.2933 13.4683 3.10916 -9.30227 +8546 4 40.0129 38.4033 12.3216 -17.7433 -13.1833 12.1033 +8547 6 30.24 35.8848 2.88572 49.7685 -5.59713 18.4489 +8548 4 29.7974 35.0543 2.80033 -9.93294 -19.906 -6.06696 +8549 4 29.6668 36.5692 2.63166 -32.6151 32.1739 -11.9765 +8550 6 50.3574 12.2906 11.0327 -10.5999 -17.0186 -10.0309 +8551 4 50.5337 13.0768 11.5186 9.60091 28.0994 7.49192 +8552 4 50.105 11.6994 11.7365 -4.43527 -18.2768 5.14926 +8553 6 38.4177 1.51331 34.6454 7.78381 -17.0522 33.0946 +8554 4 38.2699 2.04814 33.8899 -7.54861 16.9144 -29.9652 +8555 4 38.0471 0.642488 34.4678 -6.5188 -5.83242 -9.72252 +8556 6 23.4539 32.2409 29.2188 -19.2438 22.9381 45.5983 +8557 4 24.0079 32.8299 28.7229 8.54827 0.527122 -15.0299 +8558 4 23.2413 32.797 30.0413 4.80705 -31.5817 -31.7916 +8559 6 36.5701 38.8746 8.90535 32.3223 -9.33237 29.2552 +8560 4 35.9325 39.4424 8.49935 -20.4423 23.0824 -8.61697 +8561 4 36.7801 39.1579 9.82993 -12.7327 0.605838 -19.3651 +8562 6 35.8737 15.8498 32.4386 8.92141 19.9053 -4.5399 +8563 4 36.1418 15.4504 33.2665 1.19933 -3.86396 7.25653 +8564 4 36.5179 16.5897 32.2945 -14.9335 -15.4114 1.1633 +8565 6 22.2892 21.8291 41.5841 -16.2626 10.7882 17.5339 +8566 4 22.1223 22.8053 41.6744 16.5914 -23.4811 -7.73209 +8567 4 23.1242 21.6534 41.1409 10.4107 9.35007 -4.50107 +8568 6 24.3606 38.6964 37.0146 17.4204 12.5043 -4.63866 +8569 4 25.2779 39.064 36.9978 -17.1771 -5.52971 -1.04157 +8570 4 24.4186 37.9719 37.6407 -4.78215 -9.12154 5.30794 +8571 6 45.8441 22.068 16.038 0.340293 -0.250982 -17.8101 +8572 4 46.1771 22.3609 15.1533 -8.50833 -8.1377 19.1007 +8573 4 45.4344 21.1785 15.9468 10.2139 13.0315 -4.03882 +8574 6 34.0918 26.1359 39.6112 38.0511 -8.91464 13.1738 +8575 4 33.1848 26.2338 39.3827 -25.4265 4.60567 1.8853 +8576 4 34.221 26.2032 40.5833 -12.0295 -1.62025 -11.2558 +8577 6 7.22533 36.1661 23.281 -59.3132 -5.14125 -34.652 +8578 4 7.26364 37.0581 22.9295 6.20379 9.34593 -2.3157 +8579 4 7.97006 36.0735 23.8015 59.451 -4.11437 40.0555 +8580 6 29.1637 40.7448 9.14206 -2.51826 7.72751 -13.9009 +8581 4 29.0444 40.3656 8.22324 15.9504 -2.90487 33.8878 +8582 4 29.7314 40.248 9.77766 -4.36215 -9.31282 -20.9127 +8583 6 29.3678 11.2357 1.30083 -35.1077 14.24 19.1284 +8584 4 28.4669 11.4731 0.940057 29.2946 -5.02339 11.2991 +8585 4 29.318 11.4379 2.27092 4.83193 -7.95866 -28.0539 +8586 6 30.9732 3.71267 14.0776 15.2348 -46.8383 -31.5788 +8587 4 31.4582 2.88428 14.3733 -12.5046 34.6753 7.46482 +8588 4 30.8397 3.49874 13.1133 -3.67459 15.4991 23.3176 +8589 6 29.7056 15.2804 38.2794 -11.9618 14.5562 -33.6413 +8590 4 30.2702 15.1354 39.0168 20.1567 -4.59268 23.419 +8591 4 30.0841 16.0123 37.7308 -6.59039 -15.0688 15.6005 +8592 6 36.6264 0.310111 29.1514 -5.04796 -7.83703 -2.09784 +8593 4 37.4271 0.819379 29.3706 -8.93441 4.46737 -4.0897 +8594 4 35.9914 0.856083 28.6484 15.2391 -5.29618 7.37908 +8595 6 47.6417 0.116275 23.248 13.5287 8.94531 -12.2883 +8596 4 47.0119 0.433387 23.8864 -15.3927 3.59754 12.8324 +8597 4 47.4641 41.0946 23.1357 -2.49679 -12.2922 2.24912 +8598 6 7.90637 37.1762 29.9388 8.54368 22.8184 26.8453 +8599 4 7.85301 37.2098 30.9449 3.45275 -3.37357 -41.2712 +8600 4 8.44496 37.9737 29.6897 -17.0006 -23.7003 10.0801 +8601 6 38.9296 24.2329 12.6383 15.5219 -16.6974 -22.776 +8602 4 37.9787 24.1601 12.7323 -9.9748 0.376678 1.49713 +8603 4 39.1449 23.5705 11.9215 -5.67631 22.059 20.3409 +8604 6 21.3179 26.2613 36.7933 11.7928 19.07 -1.51604 +8605 4 20.8397 25.6962 36.2015 -9.60619 -6.53459 -13.3894 +8606 4 21.5182 25.6957 37.5187 2.0605 -10.1459 21.1123 +8607 6 28.2262 23.3351 24.9913 6.08955 -0.748437 0.460504 +8608 4 28.2308 24.0016 25.6964 4.22655 -6.81745 -1.24962 +8609 4 29.0479 22.8075 25.0363 -13.73 7.51762 2.95505 +8610 6 38.3897 39.5713 14.5774 34.0997 -9.77678 18.0089 +8611 4 38.4779 38.8655 15.2987 -6.58584 29.8461 -29.0755 +8612 4 39.3026 40.0121 14.5422 -41.1029 -19.3921 -1.23505 +8613 6 26.0587 6.01626 38.1331 -7.56489 -16.2073 9.45163 +8614 4 26.364 6.92283 38.0032 14.5247 -0.467326 2.92393 +8615 4 26.7573 5.38712 38.4414 -3.391 26.9876 -7.34507 +8616 6 52.1178 17.2513 22.5128 -10.8492 5.54118 7.42996 +8617 4 52.8997 17.6733 22.1718 9.92427 15.7211 -4.0445 +8618 4 52.2219 16.3395 22.2718 -2.102 -18.0313 -4.16051 +8619 6 39.531 30.2011 31.4754 1.32431 5.33104 20.3977 +8620 4 40.1389 30.6029 32.1578 -26.1612 -12.9519 -10.6425 +8621 4 38.6407 29.9778 31.8528 28.462 12.4065 1.81878 +8622 6 19.6595 6.91666 12.7659 -14.5008 4.80913 14.0157 +8623 4 19.6887 6.47111 13.6446 7.23462 -2.42447 -18.0556 +8624 4 20.266 6.55226 12.115 5.2883 -10.9354 6.21868 +8625 6 32.4266 37.4954 40.1172 13.7501 31.88 -47.4625 +8626 4 32.7425 36.6266 39.9032 -2.48661 -20.9779 5.59445 +8627 4 32.1419 37.5817 40.9958 -11.8933 -10.3197 48.8363 +8628 6 39.7596 0.337115 6.09995 15.1421 -1.66777 24.2876 +8629 4 40.1534 1.22219 6.08152 -5.11901 -0.972083 -7.53812 +8630 4 40.1657 41.8549 6.90018 -9.37436 -2.20237 -11.3555 +8631 6 28.7751 10.1584 29.138 -2.01192 2.80513 -2.93319 +8632 4 27.8238 10.1744 29.001 -3.57801 1.81269 -4.50746 +8633 4 28.8919 9.80572 30.0274 6.34341 -2.0407 -1.56061 +8634 6 28.3442 21.074 10.6333 2.67716 -1.32955 -8.08167 +8635 4 28.7162 21.9756 10.7458 1.68682 -14.6392 -2.70928 +8636 4 28.9848 20.5267 10.1317 -8.30024 16.2649 10.4277 +8637 6 27.0693 28.6863 20.8775 28.7719 -2.37794 4.3254 +8638 4 27.7298 29.2434 21.3283 -4.93173 -3.86203 -1.8773 +8639 4 26.2334 28.9344 21.2444 -24.6691 6.36732 10.1211 +8640 6 39.6873 13.9804 33.4544 10.1398 -5.61125 10.7915 +8641 4 40.0465 13.7022 34.3167 -4.86 2.4669 -10.6871 +8642 4 38.7726 13.6755 33.4723 -5.1401 -2.85022 0.606476 +8643 6 25.4597 11.6576 34.3181 14.491 -28.0098 33.8508 +8644 4 24.8514 11.0162 34.7619 5.36553 12.2612 -15.2396 +8645 4 25.0161 12.1454 33.6493 -21.152 12.7672 -16.4478 +8646 6 27.5131 37.6326 21.427 -19.9573 -21.9997 -23.7283 +8647 4 28.2253 37.2064 20.96 8.67225 -9.05343 -17.242 +8648 4 27.9596 38.068 22.1137 20.557 20.5047 35.0331 +8649 6 30.5914 20.0695 28.6348 27.7431 -17.6396 19.2377 +8650 4 30.9836 19.3645 29.1801 11.8534 20.0629 -12.5158 +8651 4 29.6982 19.8076 28.6872 -39.6618 5.20089 -10.7407 +8652 6 42.3778 1.85684 14.9393 25.4983 -1.50621 30.9456 +8653 4 41.9471 2.41032 15.6124 -5.43016 1.03086 -4.74891 +8654 4 41.8361 1.80616 14.1675 -19.8596 2.00334 -17.6468 +8655 6 12.1616 12.5321 19.523 -14.5305 -6.69845 -4.01711 +8656 4 12.9939 12.0448 19.446 -0.641831 -5.10207 -0.17564 +8657 4 11.4028 11.9007 19.4323 17.6183 8.93718 0.635936 +8658 6 19.2173 1.21358 16.3673 12.2327 1.89672 9.92834 +8659 4 19.755 0.600796 16.911 -5.77615 9.45405 -9.5745 +8660 4 19.8129 1.9499 16.1364 -2.75311 -6.47505 -0.557351 +8661 6 9.48027 16.145 27.6887 18.4383 23.7652 -21.1678 +8662 4 9.95062 16.009 26.8224 -12.6846 -2.19341 25.2173 +8663 4 9.19893 15.3052 28.0262 -3.30777 -17.5687 0.945009 +8664 6 40.4566 26.1709 24.7821 -20.4805 41.2174 -0.532491 +8665 4 40.3628 26.7039 25.5991 10.1463 -19.7663 1.05084 +8666 4 40.0809 26.8306 24.1463 10.2053 -25.1837 1.88999 +8667 6 47.6675 17.6506 18.0225 -30.0634 41.3074 12.2788 +8668 4 48.2543 17.9981 18.7254 0.401995 -10.3127 -9.33209 +8669 4 46.9068 18.3177 18.0388 29.0716 -28.5939 -1.2112 +8670 6 36.6158 25.2629 4.18774 29.3736 28.0527 4.32129 +8671 4 36.5214 25.5758 5.09839 -16.0305 -5.04511 0.138651 +8672 4 37.2819 25.9232 3.86538 -16.6324 -17.2389 -6.3952 +8673 6 39.5728 35.3879 29.6636 12.278 22.7044 -7.26925 +8674 4 39.0499 34.5938 29.661 -5.91236 -8.06683 2.48368 +8675 4 39.3907 35.9006 30.4607 -1.7908 -9.53931 -1.38728 +8676 6 0.412001 14.6096 13.3342 2.26376 -2.5079 -14.7045 +8677 4 54.7802 15.2759 13.6175 -3.32355 6.27336 -0.974202 +8678 4 0.516441 14.0579 14.0961 4.60085 -12.9246 15.0473 +8679 6 12.196 27.3305 8.43326 10.0473 13.6833 14.0535 +8680 4 13.031 26.8669 8.51701 2.31971 -16.5604 -6.51009 +8681 4 12.4357 28.1833 8.85089 -17.0888 -3.60228 -10.1051 +8682 6 36.9057 14.8161 21.1198 30.6025 20.2317 -25.7914 +8683 4 37.0125 14.4244 21.9807 1.92342 -10.2074 20.832 +8684 4 37.7936 15.2053 20.874 -24.9082 -16.5351 5.08732 +8685 6 20.8486 4.94275 21.105 17.9022 -6.61396 -0.309651 +8686 4 20.374 5.67415 21.5228 9.17185 2.06744 3.08402 +8687 4 21.7751 4.88103 21.448 -24.8745 1.45604 -2.42669 +8688 6 36.7441 1.80601 7.63303 -8.86792 14.8212 -18.8361 +8689 4 36.3577 2.71345 7.77493 14.0998 -30.8697 16.0099 +8690 4 36.9898 1.34966 8.45182 -6.21638 14.7491 3.51078 +8691 6 12.2291 31.5076 37.4606 -20.8205 4.71929 16.9336 +8692 4 12.7789 31.2189 36.7301 -1.71439 -5.19212 -6.77065 +8693 4 11.3837 31.0118 37.4916 13.4088 3.21935 -3.86138 +8694 6 38.9875 41.6041 16.8806 -4.97036 -4.86794 -9.64455 +8695 4 39.4307 41.5716 16.0177 3.10466 0.790549 7.7281 +8696 4 39.367 0.410173 17.3903 6.57234 9.13046 2.45051 +8697 6 31.8971 27.2651 22.2536 0.475946 9.95506 -26.8482 +8698 4 31.2288 26.6192 22.5148 1.53167 3.01995 -0.700727 +8699 4 31.6701 27.5469 21.3168 1.33988 -13.0026 32.8364 +8700 6 42.7373 9.18402 25.5752 -16.5205 -8.12573 12.5156 +8701 4 42.0715 8.82875 24.9549 8.97347 3.93682 -3.18445 +8702 4 43.4726 9.55718 25.0966 9.17117 4.66181 -14.1392 +8703 6 50.9317 28.1762 25.3585 1.81467 11.9603 16.0249 +8704 4 50.4332 27.6858 24.699 -7.797 -4.30978 2.61883 +8705 4 50.6061 27.9816 26.259 1.82058 -3.16123 -16.2825 +8706 6 43.2019 19.6758 30.9261 -60.5069 12.608 18.1565 +8707 4 44.1121 19.7947 30.8273 58.227 11.7487 -4.80009 +8708 4 42.8317 20.4979 31.3452 14.2318 -14.5845 -6.94071 +8709 6 30.6579 14.0392 40.8099 -3.90856 28.8453 32.4485 +8710 4 30.2625 14.437 41.6588 6.78025 -22.1962 -33.7862 +8711 4 30.2388 13.192 40.6401 -8.31431 -9.09038 5.19898 +8712 6 20.9126 15.487 23.0255 1.81996 -1.2716 -0.577536 +8713 4 20.3529 16.1851 23.4151 9.86352 -5.06847 -1.26552 +8714 4 21.845 15.6804 23.2451 -11.0139 0.781722 1.09061 +8715 6 34.2266 0.759926 35.8266 5.91607 -35.831 36.3238 +8716 4 34.6699 1.4486 36.3596 -6.19332 -9.6922 -6.67054 +8717 4 34.0788 41.8551 36.4474 5.42693 41.8664 -30.5853 +8718 6 38.9146 36.9114 35.918 21.2173 -10.8751 17.2864 +8719 4 39.7829 37.095 36.338 -12.434 5.66027 -11.9648 +8720 4 38.7157 36.033 36.27 -5.46808 2.11761 -7.10044 +8721 6 45.1412 25.209 22.7799 -9.21588 11.7282 35.1943 +8722 4 44.1635 25.1535 22.9277 18.3683 -4.67801 -8.38153 +8723 4 45.395 24.8019 21.9606 -9.08047 -9.94082 -17.9945 +8724 6 40.6079 0.819632 35.9543 -10.1658 30.0784 -5.29357 +8725 4 40.5743 41.7978 35.9297 8.39322 -37.6139 4.80851 +8726 4 39.8853 1.04128 35.3423 10.5918 6.58535 9.58714 +8727 6 11.0481 28.354 35.0263 -7.05837 2.15472 6.15391 +8728 4 11.0065 27.7661 35.7937 6.20016 -1.50115 -1.31869 +8729 4 10.2774 28.923 35.1598 -2.00076 2.29074 -4.05614 +8730 6 20.214 13.5993 35.8619 28.0429 -16.4719 23.5579 +8731 4 19.4963 13.9327 35.3857 -45.1468 12.1599 -23.9045 +8732 4 20.9404 14.0304 35.4284 21.7873 4.64258 -6.99651 +8733 6 39.6259 5.13927 1.77541 6.3837 10.5905 23.0009 +8734 4 38.815 4.76887 1.43754 -8.89155 -4.8304 -7.9643 +8735 4 40.2998 5.10051 1.09544 5.70124 1.55861 -13.0764 +8736 6 30.2644 30.8765 32.4376 2.45351 13.5189 11.7538 +8737 4 29.6638 31.1848 33.1457 1.37952 -7.29152 -6.97913 +8738 4 29.9065 30.0722 32.0512 -6.5155 -7.29863 -0.0927806 +8739 6 14.5561 10.991 22.8667 10.081 16.7623 43.7388 +8740 4 15.1677 11.6459 23.3133 -13.9792 -18.4015 -26.7579 +8741 4 13.9431 10.829 23.6181 3.59137 -7.6484 -17.8174 +8742 6 20.7554 13.9367 3.0184 -22.7431 -13.2276 -14.851 +8743 4 19.9027 13.7405 2.57467 24.082 -4.954 3.77469 +8744 4 20.4786 14.7044 3.49738 5.42185 19.6619 18.2233 +8745 6 41.2999 4.28373 12.6115 -5.11846 11.2121 16.06 +8746 4 40.5902 3.66826 12.7964 -5.45414 -3.74116 2.1628 +8747 4 41.646 4.04628 11.766 6.8814 -9.70345 -22.8074 +8748 6 10.8486 24.7151 21.7079 -22.0181 20.7635 -2.99902 +8749 4 10.06 25.055 21.1824 26.1755 -20.3138 8.68391 +8750 4 11.196 23.8735 21.3742 -8.74412 -0.217035 -8.2032 +8751 6 53.5851 20.8962 34.3615 -20.5776 4.99959 -7.54911 +8752 4 54.5312 20.9399 34.3174 23.7346 3.60458 -0.717784 +8753 4 53.3344 20.0378 34.731 7.46747 5.54606 -4.26157 +8754 6 14.8822 4.84805 30.4483 -9.71325 -6.00753 -19.6684 +8755 4 14.771 4.94284 29.4789 1.77408 0.90497 14.7496 +8756 4 14.5561 3.94513 30.5986 4.49673 6.24836 5.5759 +8757 6 48.9024 37.1196 13.1149 -36.5603 24.8322 -14.1851 +8758 4 47.9606 37.2057 13.4129 22.1922 -3.12109 -3.19476 +8759 4 49.2987 36.4589 13.6532 13.3268 -16.5999 12.901 +8760 6 26.8059 19.3169 7.54434 -4.26945 -4.42367 7.83904 +8761 4 27.1766 18.4867 7.22339 -3.92405 -4.32352 -1.07463 +8762 4 27.3968 19.9842 7.20607 8.782 12.6164 -5.40832 +8763 6 17.6305 11.9358 39.0864 -20.6439 9.19078 16.9487 +8764 4 18.5077 11.609 39.0209 28.8526 -12.5757 -8.06323 +8765 4 17.5232 12.1203 40.0373 -6.81014 1.23205 -8.73836 +8766 6 49.927 14.591 8.61416 15.5742 -26.1486 -8.96269 +8767 4 49.2009 13.9524 8.72368 2.87529 10.9098 3.94828 +8768 4 49.6414 15.4659 8.85563 -10.1676 20.5637 7.32703 +8769 6 32.3582 34.9735 31.5167 -0.414276 11.4895 24.1707 +8770 4 32.1283 34.3825 30.8126 -1.81559 -4.89127 -12.898 +8771 4 32.4479 35.8663 31.1601 -0.97656 -3.19104 -3.1743 +8772 6 11.821 22.2226 21.3194 1.12988 -20.2292 -31.7924 +8773 4 12.2035 21.6949 20.5593 -17.646 16.3031 19.3587 +8774 4 12.5076 22.1609 21.967 14.4856 1.86701 17.8995 +8775 6 33.8479 9.95925 13.6297 5.85555 4.94861 0.641841 +8776 4 32.9412 9.60258 13.4965 20.4646 2.44791 -13.0803 +8777 4 34.46 9.81143 12.8638 -25.0852 -4.3509 9.75457 +8778 6 25.5216 36.3896 1.4985 -3.83916 -1.90754 -5.44184 +8779 4 26.1733 36.851 0.947779 -3.43756 3.58217 3.68691 +8780 4 24.6678 36.8514 1.38848 10.8858 -3.23471 -1.95008 +8781 6 26.2654 10.5456 9.75524 -44.5011 8.64206 25.1655 +8782 4 25.6084 11.269 9.60979 18.788 -4.56637 -6.88642 +8783 4 25.8198 10.0845 10.5139 21.0346 7.54764 -16.1236 +8784 6 25.0247 0.792222 40.9035 16.6629 9.7536 -9.8108 +8785 4 25.2766 0.410293 40.0414 -7.0744 -0.853038 7.71488 +8786 4 25.4535 1.67289 40.8914 -6.39875 -10.0211 5.33714 +8787 6 46.2514 3.92331 24.811 2.29787 -10.4124 3.565 +8788 4 46.4476 4.07649 23.8793 1.84574 -7.0337 -1.43198 +8789 4 46.0806 2.96577 24.928 -3.00701 8.9366 -8.52535 +8790 6 21.593 13.605 29.211 2.46069 1.87638 12.7155 +8791 4 21.5518 14.2847 29.9136 -0.977025 -6.07097 -8.18011 +8792 4 21.3035 14.062 28.4178 -1.02829 3.62716 -1.29843 +8793 6 36.772 38.3747 0.364057 -13.57 -14.6746 -5.92565 +8794 4 36.4241 39.1227 0.863015 -2.10343 5.30459 -0.282121 +8795 4 36.0255 37.7419 0.250491 13.2024 11.0478 3.68109 +8796 6 19.3024 17.6377 24.0664 34.4056 30.1631 -22.0465 +8797 4 18.4191 17.3498 24.1437 -40.9446 -15.7866 5.54764 +8798 4 19.2946 18.2748 23.3003 0.347271 -14.2409 17.5238 +8799 6 23.1729 12.6936 3.50527 -23.4203 -1.67393 -9.32385 +8800 4 22.2599 12.987 3.28408 10.1497 2.83055 6.60862 +8801 4 23.2366 11.8468 3.05081 2.04707 -0.882582 2.79058 +8802 6 37.8929 8.88926 35.4532 -15.1513 -19.5409 -35.7954 +8803 4 38.8496 8.85033 35.2802 -3.80753 -1.00094 -0.145651 +8804 4 37.4409 8.32345 34.738 24.7998 24.8105 28.8968 +8805 6 14.3214 15.124 36.1936 10.1777 -8.45579 -11.337 +8806 4 15.1189 15.6285 36.3983 0.383997 -0.909139 3.4786 +8807 4 13.728 15.2114 36.9249 -8.84751 6.7001 14.2991 +8808 6 35.0764 0.951221 33.027 4.39995 -0.747562 -23.3066 +8809 4 34.9707 1.92678 33.0471 -0.901583 -14.825 16.9845 +8810 4 34.929 0.489106 33.8671 -4.79444 18.9729 2.67887 +8811 6 50.9368 0.508345 17.9996 -16.1068 -2.11236 -10.8013 +8812 4 50.7363 1.3993 17.6607 6.59543 -7.82408 5.75367 +8813 4 50.2126 41.8571 17.6452 15.113 5.01242 7.08044 +8814 6 26.2276 30.5707 0.943679 2.98972 25.4521 29.679 +8815 4 26.9747 31.0717 1.30878 -11.5718 -5.07384 -0.177367 +8816 4 26.5685 30.1289 0.190254 7.28539 -15.5247 -23.6744 +8817 6 18.5631 38.2963 4.56281 15.0547 -0.00169581 -1.07608 +8818 4 17.6313 38.4808 4.44067 -9.04909 6.52025 -3.84653 +8819 4 19.0145 38.7079 3.79419 -7.75189 -5.39823 9.30868 +8820 6 31.1327 5.08368 4.10816 20.0095 -18.3558 -6.33253 +8821 4 31.8391 4.51927 4.54922 -26.0459 18.0586 -17.7145 +8822 4 31.2112 4.96997 3.12633 -1.20575 2.29654 19.098 +8823 6 26.4386 21.9021 1.48262 11.6176 -12.3641 -2.34526 +8824 4 26.4119 22.77 1.11333 -7.24657 26.8604 -8.21156 +8825 4 27.3591 21.6321 1.37052 -1.3799 -4.61827 0.12427 +8826 6 39.218 11.6975 22.8013 10.5737 17.0434 4.86912 +8827 4 39.8837 11.6898 23.5135 -8.12783 -9.21376 -3.17514 +8828 4 38.7576 10.8611 22.7762 -0.316566 -9.51531 5.7902 +8829 6 13.6104 36.3454 30.6448 12.2201 31.8005 15.4331 +8830 4 13.9411 37.0787 31.1944 -5.64032 -6.12374 -20.8561 +8831 4 13.4819 35.6769 31.3099 -5.82879 -19.5305 -1.97286 +8832 6 50.5737 9.8729 9.34449 -28.5439 -15.8542 -0.594603 +8833 4 49.6941 9.5296 9.68217 24.5077 10.0039 -8.16891 +8834 4 50.7802 10.6382 9.87905 1.56032 8.49656 8.37591 +8835 6 49.6568 40.2957 22.5808 3.13406 -4.17489 -1.45496 +8836 4 49.9643 39.4131 22.2832 -6.04563 10.523 5.74674 +8837 4 49.4657 40.2311 23.537 6.08697 -6.10842 -7.72776 +8838 6 7.19984 41.3227 28.8903 -1.52952 20.6044 28.9443 +8839 4 7.18166 41.5789 29.8666 2.82963 -8.74683 -37.3978 +8840 4 7.33954 0.237732 28.3754 1.09714 -11.2116 9.436 +8841 6 13.0357 18.018 25.3358 19.442 16.9905 44.3108 +8842 4 13.6166 18.1186 24.5548 -1.12298 4.17303 17.3747 +8843 4 13.5323 18.3306 26.2146 -21.9746 -20.4015 -59.5043 +8844 6 50.052 19.589 2.43093 38.9512 -4.48133 -22.8803 +8845 4 50.7424 19.2598 1.79532 -23.4729 1.49397 14.1456 +8846 4 50.5528 20.298 2.8491 -7.87613 8.00017 8.65361 +8847 6 28.349 40.9814 24.5177 14.9096 -9.01222 -0.77751 +8848 4 28.8235 40.5955 23.7606 -4.31864 4.07524 4.80921 +8849 4 27.7156 41.5877 24.1507 -14.6867 11.3415 -7.76415 +8850 6 19.4129 5.36023 29.5381 -15.1481 -17.3665 11.3948 +8851 4 20.1134 5.96028 29.2689 3.1753 8.4576 0.913483 +8852 4 18.7407 5.8353 30.064 8.44892 1.72514 -6.85652 +8853 6 35.3149 40.1584 22.2743 -5.4761 3.67764 -22.0922 +8854 4 35.6772 39.8166 23.0859 3.70556 0.822605 11.3301 +8855 4 35.3088 41.1243 22.2924 6.6179 -0.993945 11.5959 +8856 6 16.1846 33.7767 9.75922 -0.358556 8.53088 17.0233 +8857 4 15.9516 33.2005 9.03859 1.48669 -13.8429 -11.0903 +8858 4 15.6081 34.5411 9.70154 -4.21994 3.45608 -1.0308 +8859 6 17.3638 40.6569 20.2187 0.0478101 13.797 12.0053 +8860 4 17.2553 39.7868 20.6094 -1.96745 -8.64858 -4.42208 +8861 4 17.5346 41.2369 20.9867 0.609446 0.00823871 -10.958 +8862 6 20.5168 9.71855 9.57392 23.3053 8.23996 -15.5036 +8863 4 21.1612 10.0129 10.2371 -5.46071 -1.58749 -5.90152 +8864 4 19.8092 9.36498 10.0856 -20.4585 -11.5711 12.7624 +8865 6 47.4431 20.1927 21.3797 46.3705 -23.5901 12.8176 +8866 4 48.2534 19.5912 21.2825 -32.1103 24.8918 7.30718 +8867 4 46.9863 20.0806 20.5604 -17.463 -0.0836882 -22.1962 +8868 6 38.4119 40.7863 37.8131 4.58972 -16.3007 -8.86139 +8869 4 38.2015 41.716 37.7675 -2.07213 19.1933 -0.538509 +8870 4 38.1163 40.4897 38.6817 -2.89344 0.451293 5.51523 +8871 6 4.78246 1.95264 13.1142 -0.962758 -11.3299 -4.56483 +8872 4 4.86308 1.24617 12.4504 1.09441 11.0888 1.2667 +8873 4 4.58181 1.48453 13.9266 -0.88642 0.622503 9.15822 +8874 6 46.8366 29.0044 2.17213 -21.5573 10.7483 2.0879 +8875 4 46.5703 29.0979 3.11526 14.9241 -10.138 -17.8178 +8876 4 47.6533 28.5191 2.04264 7.39387 -6.09514 13.7966 +8877 6 37.4332 26.1628 25.6457 0.476866 -1.57884 -3.35254 +8878 4 37.1432 25.5044 26.2761 -1.46501 -6.7424 3.65975 +8879 4 36.6379 26.5951 25.3475 -3.92424 6.80267 -0.609098 +8880 6 27.3215 4.19863 19.437 6.03131 -5.89417 1.59018 +8881 4 28.0693 4.5088 18.8685 -19.6633 0.0824503 4.70742 +8882 4 26.4692 4.57526 19.1444 8.48727 3.90116 -6.43998 +8883 6 29.5816 35.1763 32.6702 11.3433 -15.1984 -13.0035 +8884 4 29.498 34.4257 32.0309 -0.34209 19.1564 15.9908 +8885 4 30.487 35.489 32.5363 -2.16348 -1.10322 -0.755163 +8886 6 51.6039 27.3804 34.6228 -16.2846 20.7721 3.47149 +8887 4 51.9118 26.5342 34.8842 8.46829 -31.6815 14.0056 +8888 4 52.043 27.5552 33.7939 4.07896 7.882 -12.2594 +8889 6 26.213 15.718 22.6983 4.45652 -13.2698 4.19624 +8890 4 25.9644 16.5706 22.3629 -2.74203 26.12 0.0562263 +8891 4 25.9462 15.1046 22.0171 -4.99078 -11.3651 -6.14484 +8892 6 36.1284 41.1872 15.4686 -15.9675 5.34592 -0.326298 +8893 4 35.5872 40.4009 15.2728 11.0637 0.363161 -0.898578 +8894 4 37.0593 40.962 15.4319 4.98109 -12.2962 -3.97184 +8895 6 18.4605 8.81439 11.2163 9.85092 25.9028 -2.05591 +8896 4 18.8222 8.21565 11.8732 -2.65799 -9.87079 3.83174 +8897 4 17.6938 8.4288 10.8111 -9.58752 -11.4871 -1.05984 +8898 6 30.2054 21.3176 23.2008 0.0321998 2.06754 0.100272 +8899 4 29.9991 22.2239 22.9456 -2.76699 -3.99559 -1.97847 +8900 4 29.5697 20.7243 22.7648 2.21136 7.68347 0.454199 +8901 6 22.7376 2.20942 34.8415 -7.06988 -25.8748 21.345 +8902 4 22.3263 1.32441 34.7915 6.81547 13.2405 5.99888 +8903 4 22.6443 2.51876 33.959 0.748808 17.6695 -28.972 +8904 6 12.6779 2.74229 12.3423 -3.02369 13.9186 -14.8572 +8905 4 12.6684 3.63953 11.9163 1.20981 -22.4864 12.4813 +8906 4 13.1874 2.20366 11.7175 -0.841633 0.53426 4.77071 +8907 6 24.0891 30.0714 14.5767 2.26717 -13.4561 -11.586 +8908 4 23.8674 30.8343 15.1637 -15.8173 -12.4528 -15.4046 +8909 4 23.3482 29.6562 14.0436 11.1594 27.3113 22.4963 +8910 6 0.0169515 27.9037 22.8558 -22.9231 2.02358 -4.19556 +8911 4 54.5653 28.3586 23.5905 7.88497 -1.22395 1.09473 +8912 4 54.2173 27.7016 22.3138 13.4725 -1.40758 1.11908 +8913 6 12.3768 4.48401 25.8984 -1.01368 1.72138 -1.86924 +8914 4 11.999 5.34556 25.8124 1.61778 23.022 -11.6285 +8915 4 11.6412 4.07623 26.3496 -0.520107 -24.5543 7.98643 +8916 6 50.6552 14.4595 5.90563 -9.7075 2.6569 37.2621 +8917 4 51.421 15.0215 5.71422 1.2699 0.536098 -2.53407 +8918 4 50.4862 14.5526 6.9139 5.60038 -4.97296 -46.1729 +8919 6 52.566 22.8545 20.1304 -1.0263 1.56712 -17.1158 +8920 4 52.8493 23.3468 20.8979 1.30497 -0.175929 17.7779 +8921 4 52.7622 23.494 19.4302 -3.4332 -7.01119 -2.14697 +8922 6 43.5747 16.5432 12.8706 26.1082 -6.15301 -20.1459 +8923 4 44.3581 16.1075 12.4177 -27.2623 16.7463 17.9516 +8924 4 42.8105 16.3628 12.3102 -5.85283 0.59737 -2.51971 +8925 6 15.9643 16.7491 40.5889 4.71604 31.6512 -1.38133 +8926 4 16.4157 17.2981 39.8953 -10.7397 -16.8436 16.4649 +8927 4 15.6568 17.4119 41.253 8.12177 -13.8769 -14.2686 +8928 6 23.4093 18.8548 23.8539 -16.419 -4.21219 2.12821 +8929 4 23.4427 19.3457 24.6888 0.296298 -1.81048 -2.30579 +8930 4 22.5005 18.9913 23.5305 9.65682 -2.29273 2.24785 +8931 6 46.4286 3.27372 31.8783 1.50761 -1.36157 -5.63512 +8932 4 45.559 3.26328 31.468 -2.27736 -0.687336 -10.0334 +8933 4 46.2409 3.35124 32.8099 7.04458 2.11131 4.36323 +8934 6 43.404 41.0501 12.2894 -4.74196 -21.563 6.60959 +8935 4 43.6943 41.7945 12.8025 5.82787 10.392 6.16968 +8936 4 43.4921 41.2918 11.3656 -0.276957 5.00436 -10.4807 +8937 6 7.4944 32.479 29.5886 4.16519 42.7458 -9.72808 +8938 4 8.11522 31.7905 29.7504 15.4265 -22.4366 1.70525 +8939 4 8.06583 33.2868 29.4339 -18.9062 -19.2919 1.43274 +8940 6 4.77786 31.6555 22.5097 8.01353 -0.237295 6.09653 +8941 4 5.36252 32.2279 23.0433 -12.0801 1.27555 -9.50519 +8942 4 4.10079 32.1892 22.0697 5.55495 3.82082 5.5049 +8943 6 48.8707 26.8644 2.67473 3.24755 -50.1854 9.90243 +8944 4 49.7841 26.6767 3.05593 -33.5394 4.93648 -17.7122 +8945 4 48.3402 25.9967 2.74374 27.3415 43.0547 -3.91521 +8946 6 35.3704 23.2724 21.6151 -20.572 -8.60634 18.7236 +8947 4 36.1531 22.7653 21.8467 10.3528 0.763668 -1.9928 +8948 4 35.5272 23.8633 20.8878 14.153 10.3741 -19.8739 +8949 6 9.81162 37.7752 27.3066 -7.93747 -1.88745 -15.4111 +8950 4 9.56608 38.5967 27.7736 11.3364 -13.9943 4.65066 +8951 4 10.53 37.2723 27.7168 -2.00951 8.75096 9.6206 +8952 6 6.95784 10.9804 26.0002 -14.8513 -9.26658 -13.6642 +8953 4 6.43708 10.2284 25.6287 17.7452 16.2397 9.86134 +8954 4 7.32481 10.7062 26.8445 2.87033 -7.35616 11.341 +8955 6 15.9925 34.488 38.9165 -7.91378 13.4212 -4.2482 +8956 4 16.1125 33.5888 38.5756 -0.423195 -0.537141 7.5048 +8957 4 15.8451 34.497 39.8859 4.12272 -10.609 -16.5735 +8958 6 24.136 17.3087 36.1669 -1.30362 -38.1211 0.134245 +8959 4 24.6388 17.5417 36.9612 2.54889 -4.89456 5.81445 +8960 4 24.0565 16.298 36.169 6.29988 31.3296 1.89661 +8961 6 29.9661 19.0481 5.63552 -3.51045 -24.0694 26.081 +8962 4 30.059 18.4844 6.44318 1.40084 7.89656 -22.1005 +8963 4 29.4651 19.7932 5.9612 -6.50009 17.0844 0.645364 +8964 6 41.2323 14.2118 25.8708 0.538972 29.9242 -13.4546 +8965 4 41.1167 15.1135 25.4912 3.21098 -20.1981 4.76589 +8966 4 41.3237 14.3734 26.8138 2.01946 -2.10135 6.77926 +8967 6 30.5977 17.7991 37.3648 -2.09385 13.2702 -7.29075 +8968 4 30.1274 18.3693 36.6865 13.7219 -8.47854 26.2153 +8969 4 30.6897 18.2674 38.2325 -7.09621 1.58925 -18.9017 +8970 6 36.2622 35.7606 28.8616 -21.9344 -15.8478 13.9239 +8971 4 36.666 34.9659 29.2737 0.470987 14.2463 -5.72758 +8972 4 36.9609 36.34 28.5862 17.8584 7.52692 -3.58957 +8973 6 0.186361 37.881 20.3783 -19.4052 1.06805 -13.5296 +8974 4 0.625244 37.258 20.9754 1.43275 1.23053 -1.08677 +8975 4 54.3963 37.4077 20.0073 13.2242 8.68111 6.51083 +8976 6 49.5157 39.5849 25.2719 1.34086 -27.0873 28.6785 +8977 4 49.1738 39.8396 26.1677 9.83442 -4.23573 -27.15 +8978 4 49.8309 38.6394 25.3482 -11.1501 31.2987 0.525887 +8979 6 21.6501 10.2052 29.3652 1.38747 -32.8599 -17.8213 +8980 4 21.4815 11.1062 29.1158 -2.57329 19.5966 11.1399 +8981 4 21.7962 10.0736 30.3036 1.32123 13.0863 10.38 +8982 6 36.4484 30.062 0.133613 20.0221 49.2239 1.07318 +8983 4 36.3691 29.4748 41.3122 -8.72629 -28.1564 -18.1683 +8984 4 36.9877 30.812 41.6437 -16.8233 -22.5363 23.3328 +8985 6 35.2366 23.3806 39.1473 20.2218 -67.2813 -35.6269 +8986 4 34.8925 23.3776 38.2436 -2.85003 -5.00903 7.3464 +8987 4 34.9678 24.1769 39.4749 -24.7984 75.1446 29.9953 +8988 6 25.4958 17.6356 38.7131 -1.05403 5.23051 -13.5311 +8989 4 26.2557 17.1099 38.9745 11.6052 -6.82876 2.03202 +8990 4 25.6896 18.4914 39.1039 0.551448 5.55093 4.31103 +8991 6 32.6851 1.71412 15.3757 -17.1832 -26.0249 32.2484 +8992 4 32.9133 1.90091 16.3255 -0.281287 1.06348 -22.8896 +8993 4 32.1369 0.878474 15.451 14.5551 28.5253 -7.92953 +8994 6 2.74577 26.2334 40.164 -3.83079 -17.2464 -24.8373 +8995 4 2.52975 26.8073 40.8689 -10.0885 25.811 23.4985 +8996 4 3.46379 25.6906 40.4857 13.7859 -11.3271 -3.22577 +8997 6 25.4247 39.5803 6.65235 -3.20662 25.1889 -29.4644 +8998 4 26.0108 39.0547 7.19361 -10.0861 -10.9475 13.3666 +8999 4 24.4797 39.508 6.87242 11.3389 -11.2764 10.0712 +9000 6 3.89558 2.45526 21.1915 20.3615 -74.5786 -16.468 +9001 4 3.45835 1.54866 20.9342 19.9424 46.4596 11.9477 +9002 4 3.20863 3.06758 21.3193 -35.5841 29.5388 2.2294 +9003 6 19.428 35.9937 6.17834 -35.0483 8.79483 10.2733 +9004 4 18.6638 35.8781 6.77432 14.6839 -5.07873 0.0324743 +9005 4 19.0495 36.6291 5.56439 9.71061 8.85688 -10.7695 +9006 6 53.6717 10.8593 34.7958 -7.0633 -31.3632 -8.45381 +9007 4 53.6341 10.4895 35.6991 7.39736 18.8685 -12.2464 +9008 4 53.8829 11.7827 34.7263 4.03482 19.5096 16.0301 +9009 6 51.2684 14.0949 34.672 -8.65676 -1.63762 -26.9588 +9010 4 50.7715 13.5641 33.9816 13.3581 12.906 22.4054 +9011 4 51.0369 13.7812 35.5532 -5.90867 -9.66849 3.74112 +9012 6 14.4369 40.0234 28.032 -17.7583 12.3896 33.8878 +9013 4 13.8707 39.2432 27.9284 6.73847 -3.79593 -5.43806 +9014 4 14.0697 40.4885 28.8439 14.5888 -10.3946 -25.5694 +9015 6 36.0586 40.8581 1.30985 34.3129 5.11816 -1.28261 +9016 4 35.3876 41.022 1.96214 -5.4524 5.11716 12.4526 +9017 4 36.8901 41.3246 1.61712 -30.5352 -10.0787 -2.88322 +9018 6 32.5955 21.8673 9.61487 11.2903 3.47268 22.8686 +9019 4 32.2562 21.1899 9.03409 -3.19899 -6.31213 -16.1683 +9020 4 32.8032 22.6511 9.09762 -2.66985 0.307575 -11.8305 +9021 6 53.7554 11.4583 10.0657 12.5408 -15.0223 -21.3323 +9022 4 54.7025 11.5478 10.261 -4.15933 2.55001 3.12883 +9023 4 53.7605 10.7769 9.36125 -9.51558 7.63224 9.70748 +9024 6 25.4365 2.06658 35.0039 -16.8474 18.4627 -14.151 +9025 4 25.5892 2.94197 34.5728 -1.09755 -16.5277 9.12484 +9026 4 24.4603 2.05675 35.1439 15.8828 -2.54758 -2.86629 +9027 6 38.4258 16.3759 27.0837 10.3035 -3.82582 33.4754 +9028 4 38.4229 16.0362 28.0039 4.2105 -6.34073 -14.2668 +9029 4 38.1536 17.2766 27.2341 -1.96409 14.1736 -9.55492 +9030 6 11.9898 11.8134 38.076 -13.826 -2.82892 7.4824 +9031 4 12.2944 12.4411 38.7385 15.2198 2.85174 -2.31876 +9032 4 11.0532 11.721 38.3132 2.05768 -5.32701 -10.6008 +9033 6 21.1746 40.7334 25.8979 40.4357 -13.6237 -24.6728 +9034 4 20.6698 41.4315 25.4918 -16.6357 14.348 -0.996217 +9035 4 20.789 40.494 26.7242 -19.3448 -1.94923 24.9485 +9036 6 5.46053 31.2633 28.1043 10.2831 7.82506 0.3012 +9037 4 4.85681 31.7249 27.5011 4.53193 2.9664 -2.03256 +9038 4 6.18919 31.875 28.3487 -9.19227 -4.78386 -2.03476 +9039 6 38.5722 10.4288 26.6273 1.75688 -6.42268 2.69181 +9040 4 39.2722 10.957 26.2192 0.13713 -2.38088 1.965 +9041 4 38.9883 9.93745 27.351 -0.726559 6.62326 -4.692 +9042 6 34.5654 22.2334 5.77474 -10.6824 6.04198 20.2303 +9043 4 33.6505 22.4646 6.03122 6.34024 -5.77168 -8.80249 +9044 4 35.1097 22.5906 6.49609 1.67963 -6.25138 -9.01327 +9045 6 19.5088 23.4111 8.91157 10.1707 -16.3121 14.7533 +9046 4 19.7449 23.1021 9.7973 -5.16612 6.6008 -0.0119594 +9047 4 19.9964 22.8054 8.35541 -0.106246 2.40248 -11.9056 +9048 6 19.7526 39.1673 18.9392 3.41392 2.41259 -7.44399 +9049 4 20.3112 38.9942 19.7162 -9.66179 4.90282 -1.08801 +9050 4 18.9888 39.695 19.2431 8.6955 -6.10904 -0.220035 +9051 6 19.0066 16.6479 37.8897 24.9266 -16.0788 2.00499 +9052 4 18.1904 16.5622 37.4269 -20.8911 -0.0800444 -12.5516 +9053 4 18.858 17.3198 38.5387 -2.83386 13.0664 11.2213 +9054 6 46.1457 18.3015 34.4662 -13.7163 3.02283 10.6817 +9055 4 46.1788 17.7584 33.6837 2.50627 -7.36872 -12.652 +9056 4 45.2295 18.6352 34.4793 7.83367 -3.11582 0.242547 +9057 6 37.6724 4.92727 10.6572 20.6306 -0.498941 -29.5329 +9058 4 38.5268 5.23995 10.2493 -20.9001 -6.48587 16.5696 +9059 4 37.1025 4.69637 9.88262 10.9132 7.05613 26.3995 +9060 6 51.9879 36.0003 6.84307 -0.0349375 1.28893 10.7684 +9061 4 52.0937 36.793 6.30051 2.19835 -5.62517 4.5242 +9062 4 52.7425 36.0295 7.48232 -7.26034 2.01661 -20.7899 +9063 6 26.6747 12.3215 0.993928 -15.5873 -26.456 -19.7503 +9064 4 26.4829 12.3908 1.92985 -0.4811 3.80705 11.7504 +9065 4 26.1241 11.5295 0.732228 15.7893 19.669 4.48242 +9066 6 51.344 35.7707 13.5244 -1.45768 15.8539 -2.86245 +9067 4 51.4515 36.3837 12.7824 1.55721 2.40741 1.90229 +9068 4 51.4783 34.9191 13.1366 6.57206 -21.9808 -6.55402 +9069 6 1.98876 3.63996 24.5779 3.53339 50.093 -23.5227 +9070 4 1.66274 3.05681 25.2088 -14.7773 -39.8355 33.4132 +9071 4 1.68527 4.50485 24.9411 8.95614 -12.6616 -11.2736 +9072 6 33.5242 15.2767 16.4494 0.0755523 4.59339 -41.038 +9073 4 33.5553 15.5138 15.4787 -3.36737 -9.15609 28.4742 +9074 4 33.81 16.089 16.8707 2.78154 5.67933 12.8052 +9075 6 10.7376 26.5972 37.3568 -53.543 46.6204 -3.13137 +9076 4 10.2745 27.0143 38.1249 4.48347 -4.84659 -12.5134 +9077 4 11.4659 26.2171 37.7527 59.8403 -33.1666 26.4091 +9078 6 39.618 8.36935 32.0025 -18.1555 9.41152 20.5333 +9079 4 39.1948 8.91554 32.6893 14.8148 -9.04413 -3.7523 +9080 4 39.059 8.55692 31.2545 -3.75745 -0.899113 -17.0741 +9081 6 48.8678 24.2325 11.5968 8.56011 -30.9839 -7.0275 +9082 4 49.2355 23.3258 11.4382 -10.5357 21.2684 5.64902 +9083 4 49.6052 24.6956 12.0119 -1.11745 3.30341 0.0123828 +9084 6 15.7966 8.52145 22.5402 1.04041 9.04678 1.57429 +9085 4 15.9271 8.56462 21.5825 -0.708828 -3.15413 5.43528 +9086 4 15.5351 9.42629 22.7739 -0.982858 -3.13072 -0.606507 +9087 6 16.9647 23.5461 7.94634 -33.4976 4.63454 -7.56842 +9088 4 17.0449 23.8842 7.03772 17.2153 -3.19264 11.7182 +9089 4 17.7681 23.4723 8.45101 25.4501 5.7081 -7.03081 +9090 6 42.4788 26.856 6.32162 3.09129 16.6976 -8.96027 +9091 4 41.8509 27.5547 6.55233 4.05081 -5.7053 1.31186 +9092 4 43.1337 27.3683 5.79469 -5.76138 -9.42264 4.17624 +9093 6 36.7899 4.80361 30.039 -6.11534 9.52442 2.68488 +9094 4 37.0233 4.89717 30.9689 4.03122 4.23205 -0.240484 +9095 4 36.2783 4.00567 29.9694 -7.15291 -10.8132 -0.980928 +9096 6 45.6188 11.6101 3.31184 17.0103 13.4398 12.4748 +9097 4 45.8378 10.6807 3.43524 1.11174 -8.0511 2.33471 +9098 4 46.2756 12.0957 3.86714 -12.3909 -9.3108 -12.4209 +9099 6 24.8953 36.3829 21.2888 -10.2051 -4.79955 -3.81503 +9100 4 24.4947 36.4635 22.1668 10.8854 5.06826 1.45383 +9101 4 25.816 36.6689 21.3407 0.621807 2.11968 6.76072 +9102 6 31.8152 24.7333 2.44905 16.2387 18.0677 -0.666362 +9103 4 31.5926 23.846 2.71622 -2.49338 -12.6998 4.18613 +9104 4 32.794 24.7683 2.43834 -16.3068 -2.39725 -1.0987 +9105 6 24.1315 21.9864 37.2328 -11.9778 41.7246 15.7453 +9106 4 24.1531 22.9879 37.1682 1.73438 -35.6656 2.36813 +9107 4 24.6319 21.6756 36.4808 8.45953 -1.72708 -12.6617 +9108 6 37.1993 11.5451 15.0492 16.5469 7.10484 -0.527568 +9109 4 37.9299 11.7412 15.6355 19.6925 -10.3737 -3.43176 +9110 4 36.5282 11.9944 15.5291 -36.4248 10.8574 4.75341 +9111 6 36.4804 20.3298 41.7865 -14.7619 -38.0306 11.4639 +9112 4 36.2972 19.4996 41.306 -2.7681 3.32899 7.9346 +9113 4 36.9128 20.8369 41.1399 19.1888 26.5648 -23.5244 +9114 6 32.0378 37.9251 32.6621 -20.5074 -27.3147 -8.21436 +9115 4 32.5159 38.6908 32.9558 4.48721 20.2349 -0.22713 +9116 4 31.3298 38.1855 32.0457 8.6638 5.37323 8.26506 +9117 6 12.0353 39.9275 22.5179 -19.9222 21.97 13.043 +9118 4 12.3148 40.8142 22.1582 -9.65836 -22.9721 12.3921 +9119 4 11.2968 40.0749 23.1753 26.4497 -1.81786 -22.4595 +9120 6 26.3421 1.33641 19.2861 18.8224 -12.0939 15.9617 +9121 4 26.8564 0.711595 19.8557 -14.3211 16.2919 -14.6989 +9122 4 26.7977 2.18849 19.3545 -2.53714 -0.144297 -3.51109 +9123 6 5.91333 14.3058 5.68279 5.58536 -17.6781 -26.1831 +9124 4 6.35226 14.1008 4.80839 -10.2521 5.5819 21.3359 +9125 4 5.1498 13.7016 5.72209 7.95548 1.62414 0.442017 +9126 6 13.3681 23.0924 19.1542 -7.87238 10.4677 13.234 +9127 4 14.1204 22.8148 18.6592 15.6827 -8.39443 -13.4152 +9128 4 13.7622 23.5769 19.9007 -5.90355 -3.89356 -3.96922 +9129 6 23.3981 15.0775 9.7431 -16.2896 3.15659 0.0853289 +9130 4 22.5416 14.6758 9.94236 4.38356 -3.66538 1.71341 +9131 4 23.1926 15.7004 9.03099 5.43777 4.93098 -2.67512 +9132 6 49.5886 13.8369 18.4468 -1.57371 0.160736 10.1606 +9133 4 48.8725 13.4353 17.9701 -17.3578 -11.6866 0.338485 +9134 4 50.0711 14.2256 17.7358 20.2332 17.1818 -14.445 +9135 6 41.7455 5.66741 41.8995 19.0031 1.14603 7.86728 +9136 4 42.5946 5.93333 0.438032 -19.5636 -6.95293 -12.6597 +9137 4 41.9891 5.05837 41.1762 -2.65724 5.24908 4.18535 +9138 6 17.2511 35.5417 2.55548 5.2045 0.397579 1.12894 +9139 4 18.2067 35.619 2.48098 6.39755 9.05508 3.07921 +9140 4 17.0886 34.6316 2.34229 -4.27489 -11.2961 -3.02567 +9141 6 49.7041 19.8589 40.2412 43.8428 -27.8149 3.09893 +9142 4 49.318 19.0163 40.5437 -5.31641 8.5833 -2.14336 +9143 4 50.6864 19.6533 40.2493 -27.6084 12.6334 -3.24012 +9144 6 38.3071 5.82731 32.0534 -20.9946 -3.84451 12.3853 +9145 4 37.8352 6.48986 32.6009 6.6943 -7.79079 -6.23381 +9146 4 39.2094 6.1245 32.003 13.4939 6.60324 0.292563 +9147 6 16.2694 6.84865 34.0054 -5.49782 1.82896 8.85162 +9148 4 16.5828 6.71308 33.1028 9.77351 -3.29618 -0.21352 +9149 4 16.9894 6.61948 34.6288 -2.86373 0.259786 -9.19674 +9150 6 33.6805 18.2019 10.4544 40.2358 -26.4835 -11.4715 +9151 4 34.2537 18.8203 9.96489 -9.74865 -7.15313 7.53482 +9152 4 34.2179 17.3378 10.5117 -27.819 38.8859 -1.78852 +9153 6 38.8962 33.7675 36.7566 23.6769 3.34821 -39.6603 +9154 4 38.383 33.5793 35.9171 9.63189 4.7017 21.543 +9155 4 39.855 33.8637 36.4612 -29.1237 -5.01255 9.39617 +9156 6 45.367 13.0954 20.2202 -17.4715 7.54819 27.7127 +9157 4 45.262 12.6289 19.4029 4.78427 -8.6457 -19.3619 +9158 4 44.4728 13.0498 20.6095 8.33403 2.77458 -3.46579 +9159 6 36.394 32.2025 8.83838 -5.39961 -0.779561 10.8196 +9160 4 36.3766 31.4559 9.45045 4.37642 -0.919546 -0.394048 +9161 4 35.9671 32.9207 9.33542 2.20851 -0.984819 -7.57369 +9162 6 7.93081 27.8143 6.16526 -1.31132 8.47671 -18.7581 +9163 4 8.2701 27.2941 6.88743 5.87236 -5.84072 6.56369 +9164 4 8.18271 28.7096 6.41539 -7.71007 1.94397 -1.55613 +9165 6 14.2797 4.87717 33.6823 -38.1616 11.9775 -32.0892 +9166 4 13.6477 5.2447 32.9846 23.9092 -16.4836 27.177 +9167 4 14.8408 5.63056 33.8658 12.4601 7.15131 6.13949 +9168 6 12.2578 8.65243 9.85848 -4.82715 -2.24662 -5.48477 +9169 4 12.6456 8.73928 10.7118 23.7259 9.48722 19.5525 +9170 4 11.4378 8.2214 10.089 -13.622 -8.47682 -13.9839 +9171 6 29.7261 31.9842 8.54243 -17.2145 25.3825 -18.7463 +9172 4 30.1804 31.833 9.34913 11.7892 -12.8324 21.9258 +9173 4 29.6399 31.1708 8.03663 5.85846 -6.51984 4.51241 +9174 6 22.3891 10.8785 21.4662 8.73739 -5.18702 6.55753 +9175 4 21.8037 11.1386 20.7714 -14.2177 0.338512 -24.4291 +9176 4 22.2091 11.5521 22.1168 2.36988 5.22793 14.1218 +9177 6 54.1797 27.5396 12.9955 26.3988 -18.3584 17.6139 +9178 4 0.160041 27.5787 13.0909 -6.71045 -5.06664 4.99497 +9179 4 53.9798 28.2721 12.4475 -15.7222 27.4826 -22.0497 +9180 6 7.71973 13.812 20.0407 -34.9077 17.0186 -30.9147 +9181 4 8.32362 14.1503 20.6766 20.1403 8.526 22.156 +9182 4 7.35968 14.6399 19.6101 8.73645 -26.5601 8.16532 +9183 6 19.7932 0.841243 24.7869 -1.21084 18.2021 12.2367 +9184 4 19.1669 1.06895 25.5104 7.86649 -0.445713 -11.3386 +9185 4 20.4073 1.61074 24.7031 -15.4775 -18.2332 3.4978 +9186 6 3.01312 10.0986 2.94829 -27.2997 12.089 -8.88269 +9187 4 2.52802 10.9508 2.83041 12.1807 -20.5661 3.67701 +9188 4 3.91304 10.3154 3.17839 17.025 6.36995 4.07131 +9189 6 15.8857 13.0124 24.0049 15.5529 -4.67501 -5.43243 +9190 4 15.0856 13.5308 24.0834 -5.13718 6.9751 3.63726 +9191 4 16.3233 13.139 24.8614 0.105722 -2.17465 -3.852 +9192 6 17.0852 4.33969 26.9167 21.5143 -4.09641 1.48348 +9193 4 16.9912 4.27513 25.9666 -0.355278 1.74978 -10.9716 +9194 4 18.0601 4.31538 27.0472 -16.9044 3.21714 1.83131 +9195 6 33.6168 39.4091 10.6433 -2.74936 14.5855 -32.8438 +9196 4 33.9454 38.5625 10.8616 8.60753 -33.4012 17.9817 +9197 4 33.8375 39.4354 9.68976 -8.01757 16.2593 11.171 +9198 6 36.2326 1.10755 13.0941 -10.1125 -3.31802 -5.56412 +9199 4 35.6506 0.392496 13.3579 -10.7819 -8.26966 -9.36682 +9200 4 36.7599 1.20112 13.8707 17.1874 9.72194 12.3054 +9201 6 40.862 19.2925 5.11158 -0.402197 -15.9333 44.5432 +9202 4 40.3871 19.4968 4.34679 -15.032 12.6888 -52.1674 +9203 4 40.1189 19.1611 5.72143 13.4548 0.976419 10.4775 +9204 6 2.35452 37.5497 10.1778 32.5589 0.132829 19.8916 +9205 4 3.04634 37.0953 10.7141 -10.4583 9.64478 -9.40166 +9206 4 1.85979 36.8581 9.75685 -15.4906 -16.9123 -13.0897 +9207 6 8.10293 29.0334 15.8847 29.3895 -23.7333 0.542295 +9208 4 9.03551 28.6824 15.7668 -29.6945 17.5799 0.572456 +9209 4 8.18484 29.8326 16.4072 3.85606 5.10463 3.42896 +9210 6 47.3132 26.514 12.5427 4.56821 28.1849 -37.0073 +9211 4 47.5111 27.2634 11.8891 -8.56493 -28.9528 31.2783 +9212 4 47.3519 25.7475 11.9556 -1.34676 -3.33794 4.54904 +9213 6 33.5886 17.4994 0.666432 -7.15301 -2.01744 8.51284 +9214 4 32.6196 17.5968 0.930917 31.8637 -19.8727 -7.43903 +9215 4 33.9404 16.5735 0.747207 -21.2256 15.6146 2.50609 +9216 6 38.9757 15.6004 36.3686 4.31005 -11.6982 -11.4703 +9217 4 39.1719 14.652 36.4294 -3.02079 4.3409 1.02949 +9218 4 39.3764 15.8813 35.5317 -1.53099 5.14915 -0.246696 +9219 6 34.8198 34.351 9.37266 2.46578 -22.7668 -16.8875 +9220 4 35.3506 35.0289 8.96724 14.9634 11.0695 -15.2613 +9221 4 34.4558 34.8191 10.0913 -19.5236 18.4179 34.8179 +9222 6 44.9681 2.58102 14.7874 21.8703 21.498 2.75759 +9223 4 44.0383 2.44896 14.9383 -16.9502 -5.72583 1.77575 +9224 4 45.1679 3.47323 15.1264 -3.49788 -5.23458 -3.46791 +9225 6 42.6138 38.2902 19.8325 18.6047 12.1973 -29.2276 +9226 4 42.7029 39.1598 19.3445 -0.0117609 -27.8329 13.7468 +9227 4 43.0921 37.6383 19.2425 -13.1736 20.1758 17.0781 +9228 6 18.6869 26.7647 30.2619 -33.6624 -6.012 -17.6355 +9229 4 18.1258 26.7596 29.445 14.3051 -0.674317 21.614 +9230 4 19.5687 26.9499 29.9621 19.5047 4.84041 -5.57389 +9231 6 38.8661 37.7421 16.4836 -9.78438 -6.51051 7.80135 +9232 4 38.7478 36.8102 16.2377 -7.01003 6.44463 1.75037 +9233 4 39.8105 37.8446 16.5724 18.1337 5.4462 2.51551 +9234 6 49.3017 9.82081 12.5377 12.9664 18.8416 30.0962 +9235 4 48.8085 9.39111 11.8826 -17.6666 -23.7062 -38.8329 +9236 4 48.5984 10.2345 13.0427 4.42646 9.01279 7.79627 +9237 6 43.2246 7.36268 19.8264 -1.99344 11.167 24.993 +9238 4 42.5572 7.81175 20.4051 12.7818 -10.9207 -14.0727 +9239 4 44.1025 7.51179 20.2375 -5.96789 -3.6213 -7.06723 +9240 6 36.3461 38.714 4.42821 -2.77728 9.11116 8.98737 +9241 4 36.8002 39.5234 4.70824 5.05063 -6.10698 -1.49424 +9242 4 35.4394 38.9016 4.68929 -3.84434 -7.68842 -3.54296 +9243 6 27.8 17.802 15.105 0.992317 -7.44098 -8.78046 +9244 4 27.5393 16.935 14.729 3.58787 16.6938 2.50389 +9245 4 27.8517 17.6781 16.0585 0.147204 -0.130556 3.13955 +9246 6 18.0837 3.77506 37.3201 -10.3169 -12.5791 -10.2966 +9247 4 18.6663 3.07474 37.0146 -2.03685 -5.25132 -4.70316 +9248 4 18.6637 4.19691 37.9324 10.4473 20.1285 21.3871 +9249 6 7.71395 11.575 6.52222 6.59834 -21.2687 20.1659 +9250 4 7.75955 12.4254 6.93969 -0.705235 13.257 9.50392 +9251 4 7.66936 11.739 5.5978 -3.42683 1.36071 -31.338 +9252 6 31.4909 14.3449 18.0451 -1.46982 -12.276 17.176 +9253 4 32.1287 14.6507 17.397 7.38292 5.65775 -7.44504 +9254 4 32.0331 13.8785 18.7146 -6.90734 4.25576 -5.30331 +9255 6 50.3346 30.4143 8.91505 10.1635 2.25064 -1.90936 +9256 4 49.6557 30.853 8.39615 -4.47176 4.28708 -1.87566 +9257 4 50.0231 29.531 9.11356 -2.73977 -1.84009 2.34474 +9258 6 42.1686 10.1057 12.759 16.2008 2.03437 -4.20809 +9259 4 41.2649 9.83209 12.6487 -17.4225 -8.81494 -4.74081 +9260 4 42.1292 10.8861 13.3105 -1.28453 5.18814 5.66853 +9261 6 37.773 3.09539 32.5582 -5.24906 4.78867 -2.39206 +9262 4 38.0736 3.99724 32.5969 21.7942 11.3719 -4.3192 +9263 4 36.8519 3.25822 32.7463 -19.4678 -11.9252 3.55114 +9264 6 35.7586 13.1005 19.2721 9.99017 -22.7528 0.0781354 +9265 4 36.1308 13.8223 19.7887 2.26592 2.2719 5.61144 +9266 4 36.2509 12.2915 19.5517 -9.66412 15.3645 -2.5809 +9267 6 45.5318 4.12684 21.4944 7.1153 -16.224 0.922187 +9268 4 45.5588 4.23252 20.5315 -1.8039 6.94223 3.67507 +9269 4 45.7548 3.18328 21.6122 -5.15542 13.2346 -0.821742 +9270 6 16.876 1.8608 31.4782 -3.84426 -17.9183 -35.0426 +9271 4 16.0621 2.17388 31.0004 15.6258 0.929179 27.3362 +9272 4 17.1381 2.25043 32.3174 -12.6393 14.1325 4.42374 +9273 6 14.0947 4.88307 23.5769 -10.6061 -28.6131 16.0669 +9274 4 13.8059 5.76888 23.7237 -2.25817 32.588 -6.82267 +9275 4 13.6039 4.42137 24.2892 9.04813 -2.88937 -11.9208 +9276 6 38.3208 33.7635 12.3625 -16.3318 -7.70706 -26.0192 +9277 4 38.1373 32.9408 11.8506 0.297782 14.7405 12.2413 +9278 4 39.1486 33.6221 12.8093 16.0136 -1.39994 11.7584 +9279 6 35.6849 3.05753 37.6719 3.72695 1.1389 -16.7638 +9280 4 35.1101 2.5063 38.212 -4.0587 0.687226 6.19097 +9281 4 35.8854 3.87289 38.1447 -1.86413 5.08658 8.8135 +9282 6 31.3385 37.395 35.3723 -12.2239 -8.91609 34.0312 +9283 4 32.2231 37.7249 35.5382 9.93962 6.70229 -3.55138 +9284 4 31.225 37.4524 34.4409 4.86335 0.993516 -31.3389 +9285 6 52.0614 11.7324 14.0182 20.1458 -4.7001 -39.6215 +9286 4 52.0268 11.0667 13.2735 0.495691 14.4049 24.809 +9287 4 52.7095 12.4171 13.7023 -24.8081 -17.2766 13.6147 +9288 6 26.3478 3.42613 41.0189 1.80794 1.58056 -19.374 +9289 4 25.6151 4.01507 40.9203 -25.7718 5.99951 16.8165 +9290 4 26.7914 3.68675 40.2055 22.5797 -12.3384 -0.204994 +9291 6 24.3802 34.9453 11.1613 28.8325 38.7039 -6.19962 +9292 4 24.3515 34.6784 12.0652 -4.50215 -14.1529 28.2178 +9293 4 23.9023 34.3202 10.6558 -20.492 -31.6724 -14.1682 +9294 6 32.0094 7.59293 31.2147 -3.26399 8.81733 5.62682 +9295 4 32.0976 7.47613 30.2777 2.1706 -0.778595 -17.1478 +9296 4 31.5266 8.43606 31.2858 0.565291 -7.84955 4.65821 +9297 6 28.7282 2.60805 0.424377 -15.1279 1.50585 -5.39222 +9298 4 29.2952 2.36387 41.5859 -5.33248 3.35197 5.42737 +9299 4 27.7901 2.65331 0.119401 23.4632 0.0509354 2.06419 +9300 6 42.125 19.2126 9.86039 10.7783 -7.26578 33.4177 +9301 4 42.6695 19.2101 10.7019 -20.1092 0.869002 -30.5597 +9302 4 41.4363 18.5278 9.96356 3.48727 6.10561 -4.25932 +9303 6 33.0194 27.0842 8.32851 16.6372 -6.55357 -10.7525 +9304 4 33.8911 27.0001 7.90493 -7.38323 -0.765342 -2.5624 +9305 4 33.2437 27.3744 9.20899 -0.425855 7.33259 11.2137 +9306 6 4.16433 8.30018 19.1575 16.0783 -2.51395 5.95143 +9307 4 4.71165 7.98099 18.3991 -19.3854 5.29846 8.38252 +9308 4 3.22273 8.32359 18.9288 3.05712 -5.28108 -12.2975 +9309 6 20.7745 29.1912 37.0609 -25.9123 -20.3491 -5.83769 +9310 4 21.0713 28.277 37.0594 -15.1664 -12.7508 0.5123 +9311 4 21.6013 29.5933 37.1743 32.957 35.4267 8.73191 +9312 6 13.1089 4.99809 10.9103 2.80775 13.1965 -7.17841 +9313 4 13.4591 5.85092 11.2415 -2.5949 -14.1267 -1.88178 +9314 4 12.7051 5.16456 10.0462 -1.2434 3.82389 2.90473 +9315 6 37.5087 18.1031 32.5343 20.0502 31.699 14.1692 +9316 4 38.1018 18.8164 32.1735 -18.2411 -21.7333 4.56216 +9317 4 37.2041 18.4813 33.3903 1.90105 -7.17599 -12.7275 +9318 6 17.7655 33.2839 30.7231 12.9967 19.9173 -17.9311 +9319 4 17.8488 34.0437 30.1253 -3.68331 -4.50715 1.49576 +9320 4 18.5638 33.345 31.2563 4.57995 -0.934488 4.72964 +9321 6 23.1969 32.7832 9.90135 2.14033 10.4984 -5.43395 +9322 4 23.4737 31.9362 10.2634 3.28964 -4.66398 1.33779 +9323 4 22.2469 32.7196 9.72631 0.753558 0.42269 -0.434072 +9324 6 14.8911 9.35828 34.246 -8.54616 0.784134 0.501674 +9325 4 15.4672 8.59016 34.1372 5.2294 -0.0873347 -3.8795 +9326 4 15.23 10.0905 33.7027 2.53244 -1.05206 0.202563 +9327 6 31.1203 39.3599 38.5719 4.30147 -17.578 8.21172 +9328 4 31.5941 38.6377 39.0527 -10.1026 17.4492 -9.05875 +9329 4 30.4019 38.9077 38.1077 1.84332 2.82409 1.03593 +9330 6 5.29005 34.4279 28.2716 -0.764315 -10.945 -9.90403 +9331 4 5.24266 35.3772 28.447 -0.427568 -2.02335 -2.15628 +9332 4 5.18384 34.3192 27.3143 2.05225 4.04935 9.99949 +9333 6 30.3216 21.6974 14.1256 3.24994 1.03129 -0.468005 +9334 4 30.4656 20.7696 14.235 0.884625 -14.9253 16.053 +9335 4 30.3519 21.7638 13.1772 -0.963709 16.3006 -15.7103 +9336 6 23.8542 39.0018 28.2919 38.6077 23.8437 -8.99828 +9337 4 23.8505 39.6937 27.6143 9.44649 3.56781 3.51793 +9338 4 23.0185 38.6309 28.1896 -50.029 -28.3524 0.952356 +9339 6 9.61332 13.5451 16.4567 13.7131 10.5156 -25.323 +9340 4 8.77595 13.0917 16.3907 -9.93448 -5.52821 8.41851 +9341 4 9.74204 13.8378 15.5322 5.69689 -3.544 12.5309 +9342 6 25.9753 6.18174 15.7989 23.4837 -9.67411 23.9067 +9343 4 26.0218 6.10484 14.8454 5.11216 -1.95092 -7.71856 +9344 4 26.7445 5.66727 16.1761 -27.6477 18.1551 -17.3833 +9345 6 15.9921 33.6419 22.5616 2.25497 8.86036 -26.9911 +9346 4 16.0049 34.0594 21.6804 -4.22455 0.568633 15.0409 +9347 4 16.1032 32.7157 22.281 -1.05219 8.42244 16.6761 +9348 6 40.6812 13.5416 12.1266 -4.5396 -12.3661 6.74099 +9349 4 40.4134 12.947 11.4149 -4.75912 -2.4644 -8.17888 +9350 4 41.058 12.9332 12.7776 -0.386087 8.79442 1.8157 +9351 6 35.5875 40.2809 31.6993 12.2791 -13.6127 -29.8257 +9352 4 35.948 40.913 31.0681 -4.17713 12.2213 7.17402 +9353 4 35.6271 39.4709 31.1475 -9.59473 3.36029 20.1077 +9354 6 19.3493 17.5927 17.849 24.123 48.8902 3.26857 +9355 4 19.9577 18.423 17.9915 -34.5112 -38.8316 -9.06029 +9356 4 18.6928 17.806 17.1645 6.15508 1.01267 5.31501 +9357 6 7.96541 28.082 10.7737 20.0283 17.3944 8.50509 +9358 4 8.43659 28.8341 11.2297 -13.1431 -15.7733 -11.3814 +9359 4 7.20109 28.4458 10.3015 -0.215648 4.06143 0.688545 +9360 6 32.1489 39.5869 16.6475 -7.37335 1.81146 -4.92627 +9361 4 31.705 40.4043 16.3332 3.90743 -15.5774 4.53996 +9362 4 31.4977 38.8659 16.5723 3.01217 10.596 3.08762 +9363 6 35.8095 2.63602 18.127 2.07542 -14.8225 4.13142 +9364 4 34.8947 2.32962 18.1713 7.15775 -3.6283 3.09768 +9365 4 35.7135 3.4873 17.7367 2.81673 20.5762 -11.5045 +9366 6 14.9588 39.9585 36.8943 -2.86001 -28.3727 24.0409 +9367 4 15.4545 39.4909 36.2335 10.0689 -8.68258 -13.459 +9368 4 15.0094 40.8569 36.655 2.72867 44.443 -9.08423 +9369 6 18.3115 32.3916 11.4639 8.59274 12.4423 14.7113 +9370 4 18.6438 32.5881 12.3772 -9.2478 -5.5834 -23.9484 +9371 4 17.8762 33.212 11.1576 6.35145 -13.5457 0.164794 +9372 6 14.605 10.3819 4.99774 5.57597 -6.68493 12.6773 +9373 4 13.677 10.4388 4.75284 -6.10435 1.24571 -3.75468 +9374 4 14.6185 10.047 5.91478 4.2493 4.0336 -10.9734 +9375 6 2.02851 14.3408 39.1627 -4.03313 12.5981 -1.48522 +9376 4 2.74992 15.009 39.2086 -14.5088 -8.45155 5.07373 +9377 4 1.21458 14.679 39.6124 19.1623 -3.42757 -8.41789 +9378 6 7.58709 14.1522 32.4651 10.4977 19.6861 -0.504887 +9379 4 6.93593 13.6605 32.9674 -3.57672 2.30039 3.8359 +9380 4 7.5987 15.0834 32.797 -1.90079 -22.9019 -5.87851 +9381 6 6.15309 23.123 37.664 -26.7168 -14.8188 -11.2926 +9382 4 6.52639 23.9838 37.7378 17.5333 20.6862 9.20416 +9383 4 5.45539 23.2608 36.9958 8.40974 -10.7335 8.81374 +9384 6 37.3009 22.5422 4.44282 21.6187 66.9857 0.670839 +9385 4 36.5208 22.1217 4.15693 -30.5217 -23.5005 -12.8181 +9386 4 37.1232 23.5227 4.23696 10.5274 -41.8214 11.62 +9387 6 47.1349 31.0113 5.88613 -14.3653 5.64202 -58.02 +9388 4 46.9542 30.9019 6.7933 -9.29323 -2.10558 39.1512 +9389 4 46.2627 31.2059 5.44524 20.5013 -7.22248 10.5418 +9390 6 54.8094 25.5909 34.9286 -5.37395 41.5808 12.672 +9391 4 54.0266 25.5089 35.4943 -0.981006 -11.4098 -6.26775 +9392 4 0.0616925 26.543 35.1263 -1.5494 -32.4448 -11.2369 +9393 6 37.1551 2.08197 4.79239 -12.5712 23.0197 -22.5278 +9394 4 36.5844 2.86136 4.61445 9.59981 -14.8952 -2.62483 +9395 4 37.0798 1.96202 5.72873 2.5296 -7.23911 19.6989 +9396 6 22.5239 28.6012 8.91155 -7.98869 19.6075 21.4366 +9397 4 22.8946 28.4124 9.79991 -0.853296 -5.89568 -17.4096 +9398 4 22.801 27.9767 8.25343 10.1708 -14.6558 -3.7409 +9399 6 8.64208 27.1509 24.5664 -38.2161 25.5543 4.78276 +9400 4 7.71753 26.8887 24.5582 -5.16372 11.0804 -0.386298 +9401 4 9.04357 26.3309 24.4724 40.7169 -47.477 -5.23592 +9402 6 1.14997 23.727 2.4309 6.46058 8.65979 -14.8341 +9403 4 1.18232 23.9936 1.48373 -6.63581 -4.99587 16.5657 +9404 4 0.310199 23.2733 2.54924 -0.981545 -0.950126 -1.89037 +9405 6 54.3702 30.2259 27.0243 -0.035121 6.58363 -4.50453 +9406 4 54.2615 29.4654 26.4339 1.23903 8.74071 -4.24792 +9407 4 54.6064 30.9974 26.4582 -3.83852 -12.4126 5.30421 +9408 6 0.386829 8.42023 23.9938 5.00922 -16.8445 -6.80376 +9409 4 1.36083 8.4508 24.0758 -8.17173 1.21512 3.08891 +9410 4 54.9524 8.88826 24.7258 9.13745 3.54566 6.13736 +9411 6 16.8971 28.5839 33.3722 23.8511 -30.9569 -4.46587 +9412 4 17.442 28.7831 34.1436 -6.82268 9.96305 3.46007 +9413 4 17.4403 27.8723 32.949 -23.4552 19.8179 6.40974 +9414 6 33.6969 30.8931 0.141175 14.1795 0.777253 -0.635822 +9415 4 34.6278 30.5945 0.162696 -6.8513 6.78484 1.91826 +9416 4 33.3211 30.3583 41.3463 -2.66034 -4.05802 -0.0970656 +9417 6 16.2525 21.5202 34.1552 3.2099 -15.0674 -0.387853 +9418 4 16.0099 20.7546 33.5903 4.90739 13.2878 5.87792 +9419 4 16.6977 21.1376 34.9376 -8.96682 7.2262 -10.6242 +9420 6 0.22977 17.7868 35.7492 -9.57638 -14.7124 1.37696 +9421 4 54.2434 17.9569 35.6827 28.6901 -4.22084 5.11773 +9422 4 0.351694 16.93 36.209 -4.1051 13.1178 -5.65765 +9423 6 16.8289 12.2962 0.019427 11.8958 12.8939 11.6481 +9424 4 17.3016 12.8498 0.703368 -12.3262 -21.137 -14.7379 +9425 4 16.4403 11.4936 0.411486 1.39397 8.07719 2.11333 +9426 6 8.24246 9.54397 36.2629 -25.8472 21.2414 2.40819 +9427 4 7.81464 8.9356 36.8788 1.26461 -2.06425 2.56422 +9428 4 7.48979 10.0869 35.9067 16.4576 -8.29365 1.86334 +9429 6 48.5761 26.718 39.8382 -16.8767 -13.2223 25.9758 +9430 4 48.2189 26.9037 38.9774 0.202946 6.43929 -15.4249 +9431 4 49.4865 26.9849 39.8847 17.129 6.93076 -9.10183 +9432 6 35.4777 1.07865 23.1156 20.3084 9.46551 28.8556 +9433 4 36.0215 1.72656 22.6213 -7.75205 -10.5654 8.45632 +9434 4 35.804 1.12911 24.09 -10.3378 -1.68949 -45.1242 +9435 6 20.2777 30.6326 19.3782 17.168 -16.4055 9.77372 +9436 4 20.2499 31.0311 20.2788 1.56461 -6.55175 -10.0354 +9437 4 20.938 29.881 19.3855 -20.6701 22.3694 2.2449 +9438 6 44.3702 15.9458 1.58361 10.9348 22.193 31.2112 +9439 4 44.4077 15.6379 2.51116 -1.71559 -1.42871 -18.164 +9440 4 44.6431 16.8967 1.66823 -9.97295 -22.8516 -13.6111 +9441 6 53.8845 34.4651 10.6068 -24.0145 7.95167 -19.3224 +9442 4 54.4361 34.2696 11.3314 22.7066 -9.19703 33.7305 +9443 4 54.2985 35.2035 10.1555 0.2437 -1.83103 1.50375 +9444 6 46.1364 32.8471 33.519 4.96533 -12.2334 2.48444 +9445 4 45.9404 33.6629 33.0556 -3.66306 8.73713 -2.86335 +9446 4 47.0477 32.6179 33.2654 -4.26196 1.19291 1.09329 +9447 6 42.1324 21.9098 24.2239 34.4777 -24.9191 34.4505 +9448 4 43.0412 21.5159 24.3646 -28.4667 14.3091 -11.1056 +9449 4 41.7437 21.6811 25.0949 -3.80951 9.2794 -19.6729 +9450 6 8.14185 3.89847 11.6387 2.30661 -15.3192 6.95264 +9451 4 7.35197 4.1174 12.1322 -8.99547 12.8437 -2.29886 +9452 4 8.35392 3.05748 12.0535 10.9023 -1.5691 -3.31016 +9453 6 19.6413 41.6808 9.8267 1.07442 6.29255 0.337359 +9454 4 18.9204 41.094 9.57509 0.414049 2.67892 1.92063 +9455 4 19.352 0.205183 10.6506 0.427822 -12.2572 -10.0953 +9456 6 42.3157 8.41085 31.6785 13.3628 11.5473 -7.23952 +9457 4 41.3969 8.42848 31.9417 -9.73605 -1.80426 0.915182 +9458 4 42.5534 9.35818 31.5624 -0.333442 -16.319 1.99913 +9459 6 26.911 16.154 25.3637 -0.10907 13.2502 -20.6653 +9460 4 26.7939 15.8861 24.4207 -0.565005 2.37017 21.4763 +9461 4 26.6835 15.4121 25.9182 -3.52016 -12.4926 6.14171 +9462 6 48.2345 6.48613 12.6212 -1.55264 -8.09911 -9.8466 +9463 4 48.9652 6.31914 12.0011 -5.93235 3.28214 2.19301 +9464 4 47.4516 6.10442 12.1764 7.36669 2.93589 5.65527 +9465 6 53.4556 41.5274 30.6561 0.928349 -3.66285 -10.4005 +9466 4 53.9738 41.8466 29.9077 -1.68735 -3.84443 -4.80087 +9467 4 53.7246 0.16796 31.3785 5.2081 5.34012 15.7103 +9468 6 47.0719 22.4215 31.8177 3.79963 28.0651 -15.4962 +9469 4 47.8542 22.5824 31.2379 -15.4047 -7.22606 14.7582 +9470 4 46.5391 23.2393 31.6689 5.43499 -22.2824 10.2038 +9471 6 19.5241 5.44646 15.2431 57.7261 9.00726 -25.1025 +9472 4 19.973 4.5781 15.2547 -6.4602 7.66804 1.10752 +9473 4 18.6769 5.33307 15.596 -47.9766 -8.78418 19.1468 +9474 6 14.6808 30.2445 33.392 16.954 11.9814 -17.0239 +9475 4 15.1668 30.8865 32.8123 -10.4914 -16.0898 10.6301 +9476 4 15.2553 29.4559 33.3904 -4.22445 9.80292 -0.52553 +9477 6 28.4427 24.2289 10.4187 -0.774793 -27.6212 -36.8967 +9478 4 29.277 24.4414 10.8128 10.21 14.4589 20.8069 +9479 4 27.7162 24.5027 10.9517 -9.91177 12.6254 22.5109 +9480 6 5.25429 14.4357 24.4952 18.8694 8.38265 -3.5804 +9481 4 4.38598 14.1455 24.6681 -43.369 -9.18674 12.4123 +9482 4 5.45154 13.9758 23.6794 9.52503 -2.95522 -10.1363 +9483 6 26.3476 19.2988 19.1857 11.4015 -18.2951 -12.5804 +9484 4 26.5417 20.1869 19.4853 3.52858 10.6793 1.31948 +9485 4 27.146 18.9308 18.7141 -21.2465 13.7562 17.259 +9486 6 28.5834 7.44603 13.1845 8.68409 29.8386 11.3246 +9487 4 28.3961 6.55455 12.9442 -2.45324 -19.0833 -9.20205 +9488 4 29.0571 7.89665 12.4686 -5.14786 -6.54739 -1.73865 +9489 6 5.35742 27.1473 37.0464 13.0843 -4.728 13.8292 +9490 4 6.09472 26.8663 37.6487 -17.7636 2.66278 -18.049 +9491 4 5.49884 28.0724 36.7882 1.93418 -3.90879 0.386893 +9492 6 53.1466 13.4128 16.1104 33.6732 -23.607 0.886679 +9493 4 54.0532 13.0537 15.8959 -24.4904 18.1541 2.55443 +9494 4 52.6056 12.6236 16.2807 -0.490038 10.6025 -2.0621 +9495 6 45.4595 1.03561 24.6152 0.883869 7.22473 8.82703 +9496 4 44.8005 0.912307 23.9218 -0.0838502 -1.3445 -1.23214 +9497 4 44.9845 0.757767 25.4168 6.19386 0.932014 -5.94613 +9498 6 50.1542 2.38642 13.9319 -2.4774 12.931 -1.3926 +9499 4 50.7815 2.76975 13.3044 0.014285 -4.08681 1.38242 +9500 4 49.5062 3.09016 14.0651 -1.63783 -0.639647 1.83323 +9501 6 19.5885 31.0175 39.1657 -10.9837 -21.6636 -18.6241 +9502 4 19.8079 30.3148 38.4832 -5.60324 21.7545 20.6111 +9503 4 18.6148 30.9453 39.3442 26.0441 2.6939 -5.02925 +9504 6 19.2491 14.7106 10.8907 20.9533 -11.5465 -13.087 +9505 4 20.0062 14.1954 10.4207 -44.2836 18.7066 28.5885 +9506 4 18.7045 14.0688 11.3882 14.1221 2.37282 -8.47947 +9507 6 4.44986 39.5549 20.1348 -7.46971 20.8744 22.4052 +9508 4 3.99116 40.4291 20.2667 12.3042 -22.0468 -4.08326 +9509 4 4.78876 39.261 21.0122 -11.398 5.88582 -21.7205 +9510 6 29.0264 13.3645 23.891 3.80322 20.0192 21.3715 +9511 4 28.7263 12.4558 23.8574 1.87437 -3.97007 -2.19356 +9512 4 28.9189 13.5991 24.8488 7.01015 0.856522 -27.3099 +9513 6 17.0674 2.76528 17.6511 13.6679 -9.88609 -24.0062 +9514 4 16.9089 3.43106 16.9566 -0.337692 -4.66999 2.92783 +9515 4 17.7694 2.16287 17.2836 -16.7881 13.7863 9.44417 +9516 6 43.472 18.0456 17.7207 2.90116 -6.00314 -10.3001 +9517 4 43.5328 17.0661 17.6262 0.602958 19.7978 9.46789 +9518 4 43.5843 18.2505 18.6627 0.176297 -8.32564 -1.3476 +9519 6 25.7838 40.7303 1.24723 -3.64329 26.5644 -28.0564 +9520 4 26.2198 41.3001 1.88369 1.46132 -2.86659 8.1156 +9521 4 25.5777 41.3986 0.532216 -2.57635 -28.6607 13.7824 +9522 6 0.458758 22.8928 6.22327 -2.28892 -3.37321 -2.62932 +9523 4 0.911995 22.0955 5.88137 -3.49653 6.37629 4.11618 +9524 4 1.15027 23.4262 6.63616 1.38998 -0.611711 -3.15133 +9525 6 26.2502 35.0072 18.629 11.2346 5.37396 -16.6635 +9526 4 25.9102 35.926 18.5821 -1.77201 -16.2127 4.61622 +9527 4 25.7094 34.5197 19.2578 -0.594129 4.22999 1.61862 +9528 6 16.1509 31.8837 7.54876 40.1408 -29.5169 -1.86921 +9529 4 16.9528 31.2446 7.38162 -38.5191 36.6879 6.5811 +9530 4 16.2422 32.6162 6.9246 8.25996 -4.45471 -3.71716 +9531 6 22.9569 16.8424 28.5503 -18.0144 15.9011 -12.9281 +9532 4 23.0242 16.0615 27.9964 2.65193 -8.47258 -0.731728 +9533 4 22.0914 17.2685 28.2981 23.9965 -14.5366 15.8079 +9534 6 48.817 29.3453 32.1483 10.2159 -3.67765 25.2301 +9535 4 47.913 29.23 31.8533 -10.4354 1.38436 -5.08298 +9536 4 48.8482 28.9579 33.0615 0.343667 8.53482 -20.1614 +9537 6 13.1275 24.857 5.54597 -15.7655 12.0094 -10.6158 +9538 4 12.8967 24.1126 4.95892 -3.19147 7.26676 2.83523 +9539 4 12.4206 25.5605 5.45199 17.9822 -22.1189 1.55356 +9540 6 10.967 20.7149 15.8389 3.49035 -8.57129 -4.90872 +9541 4 10.8232 20.5385 14.8814 6.84933 2.21154 19.4522 +9542 4 11.8211 20.2878 16.0966 -18.2767 7.30584 -13.8769 +9543 6 13.8574 18.376 6.9425 -18.5688 18.5302 -26.9748 +9544 4 14.0551 19.3329 6.99178 3.58444 -10.9562 5.12073 +9545 4 14.2751 17.8929 7.64202 12.8225 -6.30863 19.0643 +9546 6 13.8485 12.9413 30.6405 -7.33075 -24.1801 -9.47477 +9547 4 13.9233 12.3923 29.8469 14.5901 9.31788 -1.12157 +9548 4 13.0284 12.552 30.9634 -3.13873 11.8242 15.1361 +9549 6 17.1199 6.33729 31.2705 58.4108 60.4292 21.9502 +9550 4 16.7347 7.19592 31.0485 -2.55536 -2.82538 -1.05014 +9551 4 16.4932 5.72664 31.0455 -61.4006 -55.6776 -22.0804 +9552 6 7.63858 23.4232 20.5528 2.70849 -2.51933 -11.6338 +9553 4 7.34936 23.0623 19.6936 2.42656 1.66026 8.60009 +9554 4 8.06294 24.2698 20.3247 -2.54411 -7.58863 2.30144 +9555 6 15.6012 36.6828 25.6308 12.0382 0.865576 2.42327 +9556 4 16.546 36.4866 25.8589 -19.7129 13.5166 -7.57965 +9557 4 15.5566 37.5233 25.1245 15.7859 -9.47529 6.9914 +9558 6 0.738662 10.4099 22.1708 -26.6289 -22.4058 -14.7131 +9559 4 0.0268398 10.3645 21.4686 20.8647 0.21224 20.3485 +9560 4 0.555589 9.63254 22.7491 3.84168 18.0907 -12.5939 +9561 6 33.5034 17.3959 33.5951 21.201 30.6084 -13.4811 +9562 4 33.5895 18.3893 33.3705 0.776259 -45.1899 5.95193 +9563 4 34.1847 16.8766 33.1005 -9.04546 14.4589 8.38708 +9564 6 21.6622 19.013 20.7578 31.9274 -22.1518 -4.15649 +9565 4 22.4096 19.6032 20.9777 -11.5486 -3.71871 -1.82252 +9566 4 22.1307 18.1402 20.6082 -20.9219 25.304 3.1187 +9567 6 41.7583 19.992 16.8792 -6.68772 4.02339 -8.69865 +9568 4 42.2438 19.1637 16.9575 3.64207 -5.49479 0.617993 +9569 4 41.579 20.1273 15.9247 3.71595 -2.33609 11.0843 +9570 6 12.0355 14.9654 17.6922 -21.5841 1.26502 -18.8824 +9571 4 11.2182 14.5976 17.276 14.8021 5.3277 12.4216 +9572 4 12.4319 14.255 18.1907 -0.352973 -10.2116 7.98966 +9573 6 23.0172 11.4191 40.7206 -10.7217 24.0381 44.0704 +9574 4 22.9528 12.3236 41.1181 -0.480688 -24.3492 -4.33206 +9575 4 23.3445 11.5906 39.8675 15.3819 0.516123 -37.823 +9576 6 21.0055 28.3299 24.5595 -23.1154 26.0001 -7.02903 +9577 4 20.2855 28.1767 25.1713 -12.8069 16.7504 -3.2857 +9578 4 21.5564 27.6405 24.838 35.6802 -30.9994 4.41974 +9579 6 19.406 13.705 31.9364 14.5236 -8.57279 10.3452 +9580 4 18.7521 13.9469 31.2876 -5.81883 0.611034 -8.78432 +9581 4 18.9142 13.6788 32.7621 -0.186305 1.04404 6.29106 +9582 6 21.5918 2.86134 24.7058 -12.3779 12.1824 -8.79066 +9583 4 21.7274 3.16074 23.7816 9.4572 -7.89437 13.7797 +9584 4 22.4025 2.45534 25.0386 5.22934 2.42127 -4.70961 +9585 6 11.3487 29.9838 18.827 10.5554 -3.16976 4.47537 +9586 4 10.5352 30.5203 18.751 15.2364 -2.61973 2.60085 +9587 4 12.0043 30.4181 19.4217 -22.0541 -6.82347 -15.9561 +9588 6 14.6417 22.3529 8.3686 35.183 35.1516 7.4005 +9589 4 14.0314 23.0645 8.61446 -9.87113 -8.59651 0.991548 +9590 4 15.5117 22.8693 8.31218 -34.203 -30.7208 1.23805 +9591 6 43.9533 23.6664 17.2647 -9.15762 31.6597 -10.4885 +9592 4 44.7744 23.2846 16.9678 11.7125 -13.1472 -3.62648 +9593 4 43.5104 22.9908 17.7726 1.91474 -8.51607 6.21827 +9594 6 28.003 25.5014 27.4986 6.23457 -29.1533 -5.23677 +9595 4 27.4849 26.2827 27.5489 -17.6876 27.9136 1.36856 +9596 4 28.906 25.8001 27.3829 8.21911 6.89622 0.0845564 +9597 6 19.1046 26.8047 33.1413 12.2661 11.24 -48.0243 +9598 4 19.0365 26.4782 32.1917 1.11076 11.999 35.7369 +9599 4 19.4769 27.7251 33.0545 -9.7287 -23.6705 8.34301 +9600 6 6.37289 19.3428 5.67363 -3.21133 -16.2285 8.07537 +9601 4 6.7336 20.019 5.09886 3.22925 8.22387 -6.14542 +9602 4 5.58923 19.7346 6.08082 -0.796808 3.74051 2.3056 +9603 6 37.4835 28.3972 9.67963 -16.8252 8.64443 -22.9196 +9604 4 37.8384 28.0931 10.5154 1.79485 -10.7977 1.13655 +9605 4 37.3056 27.6421 9.07717 9.05958 5.47813 21.4583 +9606 6 17.6994 27.086 11.7957 -23.9049 -9.71644 -0.114793 +9607 4 16.9894 26.5877 11.2784 19.3807 18.9653 23.0761 +9608 4 17.3772 27.2467 12.7205 1.32974 -4.86863 -22.184 +9609 6 12.8804 1.95044 24.1635 -16.9081 23.6463 -41.3936 +9610 4 12.0123 2.42693 23.9788 24.6345 -20.1638 18.4271 +9611 4 12.9602 1.63912 25.0531 -11.2641 -4.9093 21.6908 +9612 6 27.8486 37.1249 33.3037 14.5525 0.843809 -12.8082 +9613 4 27.8306 37.7566 32.5563 -0.261378 -9.54721 11.1245 +9614 4 28.4641 36.389 33.0416 -14.495 18.5162 4.94281 +9615 6 18.6769 12.3657 6.31954 -0.243732 -29.9473 12.6257 +9616 4 18.5317 11.3932 6.23771 0.963018 17.4883 6.62231 +9617 4 18.5535 12.6707 5.42951 -3.51714 10.9469 -19.8301 +9618 6 10.1845 29.3127 24.783 -1.36331 5.89889 -4.08473 +9619 4 10.7465 29.1085 25.5662 -10.353 -5.60455 -9.55427 +9620 4 9.5047 28.6152 24.6271 17.6265 9.93184 12.3415 +9621 6 7.25219 3.30976 16.2618 16.5712 6.01323 38.0962 +9622 4 7.85224 3.92676 16.743 -7.28275 2.21025 -21.7569 +9623 4 7.07626 2.67339 16.9792 -0.839688 -3.96601 -21.0406 +9624 6 32.2032 37.556 1.10106 -1.45173 2.30566 -1.67736 +9625 4 31.7319 37.0242 1.72254 -12.3544 -30.6614 1.12887 +9626 4 32.1826 38.3533 1.61216 9.84976 31.1212 -1.90535 +9627 6 10.4132 10.1536 6.41547 2.6172 -5.66149 -5.23088 +9628 4 9.51094 10.4988 6.43252 -1.43241 7.72691 5.99088 +9629 4 10.888 10.4598 7.20926 -10.4429 3.02901 -4.20627 +9630 6 16.1922 23.2473 37.3836 13.4596 17.9231 -6.20094 +9631 4 16.4628 23.5362 38.2769 -1.8179 -2.41291 -6.91424 +9632 4 16.622 23.8878 36.7607 -9.68345 -13.0364 13.8052 +9633 6 24.0933 14.3373 36.5438 -0.810617 7.47513 6.008 +9634 4 25.0172 14.0983 36.6068 9.64822 -3.29568 0.232999 +9635 4 23.7283 14.0715 37.4031 -3.57511 2.15125 -3.19243 +9636 6 27.4694 18.5535 28.7878 -22.2405 -8.90967 9.68842 +9637 4 27.2463 18.155 29.6474 7.14424 4.94771 -10.1046 +9638 4 26.6163 18.5328 28.3045 10.7583 2.44378 -0.411902 +9639 6 51.5617 10.4928 1.56364 -46.044 -5.31617 -17.9438 +9640 4 50.711 10.1131 1.91707 23.1705 13.8427 -10.0979 +9641 4 52.2015 10.4284 2.24991 18.8641 -3.04547 25.194 +9642 6 31.1163 39.6073 27.5052 16.7753 -4.77526 -29.689 +9643 4 30.6203 39.2762 28.2489 -5.6675 10.9492 15.0474 +9644 4 31.3773 40.5466 27.6182 -8.67746 -20.5696 10.3555 +9645 6 6.90447 35.9666 14.3264 -30.1691 -4.34312 14.222 +9646 4 7.61578 36.3042 13.808 21.2575 5.14969 -9.00238 +9647 4 7.11482 35.0613 14.5906 3.01946 -0.973686 -2.74545 +9648 6 45.5514 7.57029 29.1841 -25.615 -5.69379 -2.02895 +9649 4 44.9198 7.51228 28.4263 15.6429 0.393509 16.1679 +9650 4 45.0848 7.11279 29.9186 7.09759 5.05324 -8.24334 +9651 6 31.3626 20.5603 31.6216 46.5235 7.85379 -13.5612 +9652 4 31.9622 21.3332 31.7077 -20.5518 -6.12612 6.97271 +9653 4 31.9328 19.9839 31.0823 -17.3109 -3.90007 7.28444 +9654 6 43.0286 31.1606 10.377 -16.6603 7.93207 28.9623 +9655 4 42.0878 30.8529 10.4887 24.119 8.07098 -2.29185 +9656 4 43.3099 31.4942 11.272 -6.72297 -13.7816 -28.1326 +9657 6 50.925 25.5606 12.6461 -27.6852 -6.08767 20.8539 +9658 4 50.917 26.3683 12.1731 -8.31821 35.0391 -16.2433 +9659 4 51.8024 25.2628 12.5325 34.7451 -18.8429 0.848912 +9660 6 29.3305 2.97987 3.64738 17.2649 -36.5424 -5.61333 +9661 4 29.6156 3.84373 3.86529 8.03017 35.8359 9.57326 +9662 4 28.4158 3.03535 3.41816 -23.9953 6.75187 -10.8335 +9663 6 53.9216 32.1051 20.3724 -11.2223 -0.478332 -4.16652 +9664 4 54.8523 32.157 20.1701 8.27859 1.2318 1.83366 +9665 4 53.5473 31.7256 19.5583 -4.88871 3.83013 8.11791 +9666 6 41.7036 29.5569 6.48267 17.2638 16.7804 -5.64052 +9667 4 40.7698 29.5903 6.27928 -11.16 5.83742 -3.44443 +9668 4 42.1548 30.305 5.99503 -16.5783 -19.3567 12.2041 +9669 6 37.8345 24.5719 39.3019 -13.0469 -9.65298 -3.86921 +9670 4 37.225 24.2046 38.6488 4.5791 4.74434 1.49749 +9671 4 37.4276 24.3068 40.1372 5.55374 4.45167 1.85829 +9672 6 46.5621 27.5658 23.2944 -23.9279 -33.0439 -11.1022 +9673 4 46.4387 27.4786 24.2739 -2.64996 -4.90603 -22.3791 +9674 4 45.938 26.8598 22.8442 32.7587 35.3455 32.269 +9675 6 9.23408 27.197 8.34767 -28.7607 6.82988 18.9345 +9676 4 8.89078 27.6282 9.16421 9.10203 -8.06063 -16.3167 +9677 4 10.1694 27.1106 8.44975 24.8451 0.83524 4.07321 +9678 6 36.0586 34.168 13.9947 0.546429 -20.5208 -0.995849 +9679 4 35.8317 33.2019 13.9926 1.47243 21.3574 0.844463 +9680 4 36.7518 34.2454 13.3214 -1.12661 -0.38848 2.20278 +9681 6 51.6812 14.492 12.3108 14.2062 7.57429 -10.7818 +9682 4 52.2015 14.4126 11.4771 -7.23407 7.45688 18.698 +9683 4 51.902 15.34 12.7416 -3.60656 -14.3916 -9.37264 +9684 6 15.248 19.6366 32.4109 27.4357 -16.6396 -20.9158 +9685 4 15.2931 19.2358 31.5053 -3.54534 7.22564 18.4797 +9686 4 14.3328 19.7639 32.5881 -28.0981 2.1384 2.91772 +9687 6 27.6849 24.6479 38.3573 2.41004 -14.3506 -18.7558 +9688 4 27.9256 25.2107 39.0738 -0.349992 17.1553 25.2623 +9689 4 28.4455 24.6938 37.7731 2.45273 -2.47407 -6.18841 +9690 6 37.5344 9.26205 13.6222 2.62805 -1.42602 2.92011 +9691 4 37.9029 8.73293 14.3466 0.897712 0.834078 0.0180659 +9692 4 37.323 10.115 14.0326 -0.799981 -1.44542 -1.10758 +9693 6 20.9013 33.2307 26.2512 6.46074 3.54373 3.40895 +9694 4 21.2661 33.4546 27.1222 -3.70394 5.03607 -5.2507 +9695 4 21.0534 32.294 26.1755 2.06129 -12.757 -1.69162 +9696 6 6.58179 13.9421 35.2385 -0.161437 -23.8226 2.06013 +9697 4 6.46846 12.9778 35.1898 -10.847 5.63462 -0.921172 +9698 4 7.53649 14.0007 35.2781 8.40152 11.229 1.63712 +9699 6 10.0736 7.47184 6.87074 6.29005 1.76204 -5.26249 +9700 4 9.16789 7.18556 6.66525 -0.124912 3.45645 -0.864518 +9701 4 10.1825 8.41968 6.63706 -5.90018 -13.0861 3.35766 +9702 6 31.1989 5.96627 11.4256 47.5137 28.7614 23.6553 +9703 4 31.4466 6.13876 12.388 -20.2952 -9.94335 -33.1747 +9704 4 32.0308 6.26994 10.9806 -22.1211 -12.2896 5.82222 +9705 6 12.1387 3.84993 35.2935 2.49551 -0.304387 23.4243 +9706 4 12.8187 4.19174 34.7257 10.4227 4.50872 -14.559 +9707 4 12.5185 4.00559 36.1769 -9.60543 -1.42105 -7.76228 +9708 6 5.33665 6.07757 27.6447 8.69228 -34.5823 40.5077 +9709 4 5.10952 6.83187 28.1919 -5.14709 12.9851 -0.252954 +9710 4 5.24124 6.31071 26.7545 -7.00092 22.4827 -45.3835 +9711 6 13.1372 33.5675 1.68451 12.1014 31.5323 -4.45098 +9712 4 12.5865 33.1501 1.03303 -8.81838 -7.47149 -8.20936 +9713 4 13.3352 34.4765 1.32576 -5.5291 -24.3721 14.4697 +9714 6 44.6567 10.4099 29.0319 -12.4525 3.56979 -21.9228 +9715 4 44.5737 9.45178 29.0051 9.95574 -3.72472 2.79876 +9716 4 44.0317 10.7133 28.332 10.7873 2.60441 13.9487 +9717 6 9.14585 24.5947 6.38022 15.9839 26.3438 -7.73853 +9718 4 8.92734 24.382 5.47582 -9.1117 -9.61509 -8.5024 +9719 4 9.72625 25.3768 6.21639 -5.50996 -10.1894 15.5503 +9720 6 52.5653 27.2618 21.6392 -6.48047 6.16108 13.4347 +9721 4 52.5564 26.3196 21.8908 4.78081 5.6644 -14.1528 +9722 4 52.8195 27.3969 20.7225 3.24319 -11.7343 -6.41363 +9723 6 7.29679 16.9603 33.544 -1.27463 2.76823 -11.9762 +9724 4 7.39152 17.7215 32.9493 2.03275 -0.910573 2.88066 +9725 4 6.37085 16.7082 33.4809 -4.66481 0.778096 -0.770576 +9726 6 43.9289 25.2227 7.97871 -4.96366 -10.0233 8.38699 +9727 4 43.2519 24.7308 8.49213 12.2574 5.67032 -8.3389 +9728 4 43.4276 25.9018 7.51862 -3.04483 5.5605 -3.23664 +9729 6 2.07953 27.1233 13.6028 0.0104954 7.16496 -8.77242 +9730 4 2.15896 26.2371 13.9627 -2.1358 -7.6126 6.04882 +9731 4 2.6502 27.1018 12.8141 -2.23666 2.89631 3.72058 +9732 6 37.3141 18.284 2.18477 -5.94753 -1.23785 7.60386 +9733 4 37.4961 17.5691 1.55591 -3.17432 -0.490531 -1.7774 +9734 4 36.7255 18.8979 1.7415 -3.03937 1.4219 -5.67571 +9735 6 25.0022 10.0655 0.429871 -30.1443 -7.37242 -0.593153 +9736 4 24.272 10.366 41.7528 14.2211 1.75124 5.05026 +9737 4 24.5705 9.40237 1.00583 14.7283 12.1051 -6.86513 diff --git a/examples/amoeba/dump.ubi.32 b/examples/amoeba/dump.ubi.32 new file mode 100644 index 0000000000..743c5e68dc --- /dev/null +++ b/examples/amoeba/dump.ubi.32 @@ -0,0 +1,19492 @@ +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +9737 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 5.4990000000000002e+01 +0.0000000000000000e+00 4.1909999999999997e+01 +0.0000000000000000e+00 4.1909999999999997e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 9.9631 5.60476 0.008413 6.29384 29.5246 19.0744 +2 2 9.59585 5.61686 40.5223 49.6095 -15.082 -19.7261 +3 2 8.19009 6.07902 40.3725 -38.3002 -36.0401 31.6494 +4 3 7.228 5.27674 40.5663 25.6537 34.3003 -15.2325 +5 4 9.24854 5.32486 0.671238 -4.4712 -3.37565 -7.28982 +6 4 10.3108 6.54317 0.309331 -11.8382 -28.5043 -8.77497 +7 4 10.7093 4.95217 0.170763 9.79439 -2.80927 4.02983 +8 4 10.3426 6.38567 40.0332 -19.5644 -29.2331 3.89265 +9 2 9.77742 4.13431 39.9813 -28.2245 -12.7597 2.79543 +10 2 9.48564 3.81758 38.4974 43.5672 -24.1926 -8.96475 +11 5 10.1176 2.11667 38.0047 -9.19737 11.9016 12.5734 +12 2 9.21456 1.10205 39.2112 31.2522 23.9396 11.6177 +13 4 8.99594 3.48122 40.5964 28.5446 19.8656 -13.413 +14 4 10.8136 3.75653 40.1807 -3.6049 4.77507 7.99264 +15 4 10.0744 4.47991 37.8007 -16.03 7.55553 14.4224 +16 4 8.42529 3.84402 38.2863 -20.8998 9.83371 -6.83213 +17 4 9.47601 1.46641 40.2263 -2.07893 -1.87234 0.341628 +18 4 9.53146 0.065851 39.1813 1.34892 -20.4385 -9.90461 +19 4 8.1577 1.22135 39.0727 -30.8502 -1.48556 -5.54631 +20 1 8.07565 7.408 40.3203 38.3461 4.68909 -14.5778 +21 2 6.84679 8.08521 40.1985 -59.0929 12.5985 8.76694 +22 2 6.18936 7.48414 38.9048 -11.7821 0.575019 41.3478 +23 3 6.7346 7.67531 37.8418 13.9355 0.826162 -41.115 +24 4 8.95137 7.92937 40.1018 -13.7432 5.12585 4.7357 +25 4 6.17099 7.78674 41.0889 17.7478 9.29385 -16.8634 +26 2 7.04543 9.68435 40.1788 6.06779 -36.4281 36.3417 +27 2 5.78315 10.5437 40.1541 10.0153 13.6856 -31.2349 +28 2 4.87823 10.4891 38.8981 8.0898 32.2503 -21.0798 +29 3 5.10035 11.2936 37.9551 -6.38068 -25.249 23.2549 +30 1 3.78765 9.69754 38.9447 7.74282 -10.5609 -2.0448 +31 4 7.77413 9.91905 39.4336 6.93206 10.4159 -38.5359 +32 4 7.65159 10.0279 41.0787 -15.5363 -12.6708 -2.68622 +33 4 6.21166 11.5927 40.0353 -14.0103 -9.11046 14.0038 +34 4 5.24199 10.4471 41.1154 -6.90019 6.03163 0.39253 +35 4 3.64982 9.13451 39.798 -8.63839 -3.4701 -4.98201 +36 4 3.18526 9.53497 38.0983 12.4509 11.2825 18.2671 +37 1 5.03649 6.76821 39.0271 29.2025 12.626 -49.9624 +38 2 4.1742 6.30537 37.9199 2.45922 -5.77224 11.4432 +39 2 2.7281 6.64357 38.2301 -33.27 13.9739 -28.2234 +40 3 2.48558 7.27851 39.247 -7.20167 1.94081 18.2399 +41 4 4.56901 6.92293 39.8729 -36.0812 -3.10094 47.9009 +42 4 4.41115 6.93099 37.0362 4.08063 -6.87028 -11.6053 +43 2 4.30896 4.77224 37.6863 5.60806 -34.2262 -10.7438 +44 2 3.61194 3.83713 38.7945 21.7291 41.8848 -7.6362 +45 2 5.81981 4.32753 37.5156 -0.302636 -10.5955 -12.2236 +46 2 3.74184 2.37563 38.4472 -21.3499 -20.7746 -35.862 +47 4 3.79188 4.51145 36.7016 6.3754 10.432 9.00978 +48 4 2.54774 4.08441 38.8361 -15.7139 1.18722 1.17999 +49 4 4.01487 4.13828 39.7949 0.987415 -11.5324 -1.87366 +50 4 6.38959 4.49596 38.46 -5.87199 -9.93517 1.91854 +51 4 6.36771 4.97617 36.7815 -14.8228 -10.6264 -0.132465 +52 4 5.90888 3.19548 37.1534 1.72477 39.701 11.5881 +53 4 3.39383 2.18531 37.3739 6.37275 7.50384 16.1992 +54 4 3.10231 1.69487 39.022 -2.76045 -1.11045 15.6564 +55 4 4.76015 2.00007 38.4839 16.883 -5.45935 8.37891 +56 1 1.68415 6.36719 37.3348 37.2769 -12.9922 15.6035 +57 2 0.304736 6.65563 37.6783 -19.186 -35.7743 -0.468083 +58 2 54.3638 5.41499 37.39 23.5408 9.01503 -19.9847 +59 3 54.8016 4.481 36.67 -18.0502 12.9096 17.6943 +60 4 1.81134 5.6821 36.5646 -2.38907 6.77101 2.69516 +61 4 0.26398 6.68603 38.7911 -5.02605 17.0245 3.77253 +62 2 54.6928 7.87629 36.9427 9.14228 37.5998 28.2049 +63 2 0.656467 9.08157 36.7109 -0.0956801 -8.96924 -14.639 +64 2 1.56488 9.23116 35.5658 -28.7887 -16.4207 21.28 +65 2 0.518242 10.1807 37.599 12.0453 -33.0617 -42.3022 +66 2 2.2549 10.4284 35.3456 -0.685553 9.51875 21.9154 +67 2 1.26608 11.2953 37.3573 -6.55985 56.8791 72.0683 +68 2 2.14201 11.4551 36.3269 43.9558 24.4422 -61.5967 +69 4 53.8494 8.28091 37.614 11.6877 -9.2043 -14.6276 +70 4 54.1796 7.56606 36.0251 1.84695 0.514683 -15.8045 +71 4 1.67027 8.40603 34.832 -2.56062 3.42592 3.08894 +72 4 54.8243 10.1788 38.4192 -16.1978 -2.83683 23.7337 +73 4 2.90465 10.5398 34.4584 1.04403 1.06161 3.93542 +74 4 1.2044 12.0958 38.199 3.2453 -15.1518 -32.2206 +75 4 2.76002 12.4636 36.1598 -24.4207 -43.5556 11.8549 +76 1 53.0705 5.5478 37.8043 -13.4682 25.7632 10.8407 +77 2 51.945 4.63101 37.5291 33.8243 -29.5042 -37.7332 +78 2 50.7838 5.44293 36.986 4.21111 -0.422475 -19.7833 +79 3 50.2621 6.29965 37.7355 -1.55474 -12.1519 -25.7528 +80 4 52.801 6.45436 38.3333 3.61532 -42.2821 -15.9338 +81 4 52.3053 3.83112 36.7028 -14.0928 30.7972 24.0178 +82 2 51.5456 3.79903 38.7793 9.75018 1.06621 4.26496 +83 2 50.3519 2.79661 38.4832 35.7171 10.1602 1.47909 +84 2 52.8174 3.02556 39.2171 -10.4567 -30.55 12.3487 +85 4 51.3202 4.51835 39.6193 -10.3559 -7.38818 -7.14654 +86 4 50.5612 2.13754 37.5331 -9.75373 16.6535 26.894 +87 4 49.4557 3.43665 38.3668 -10.8276 -7.01925 -6.76558 +88 4 50.2008 2.17632 39.4156 -2.83245 -1.1989 -13.0752 +89 4 53.3224 3.52205 40.064 3.32837 5.49303 2.41605 +90 4 53.5736 2.86114 38.4382 5.5955 2.25759 -8.48168 +91 4 52.5769 1.98664 39.5815 -0.855844 10.0945 -0.110617 +92 1 50.4393 5.19673 35.6351 -19.7264 9.67141 42.9571 +93 2 49.1691 5.71413 35.1171 8.57247 21.8964 -7.76629 +94 2 48.0882 4.65728 35.3507 -19.9883 30.8425 14.9148 +95 3 48.2827 3.53875 34.9335 -4.48089 -38.0316 -8.70437 +96 4 50.7426 4.33028 35.1784 2.31221 -1.81777 -1.86606 +97 4 48.9711 6.6281 35.7521 -11.2206 -0.672417 -16.6265 +98 2 49.2032 6.03091 33.5236 -0.851856 65.2811 26.1578 +99 2 47.9587 6.87959 32.9935 21.6676 -24.5773 11.3759 +100 2 48.0434 7.32811 31.5002 51.7858 -12.5586 -5.19204 +101 2 48.2074 6.22405 30.3724 28.294 -23.2516 17.4346 +102 1 48.1983 6.77555 28.9911 -71.9632 -28.6889 -6.605 +103 4 49.3393 5.11986 33.0139 -2.20502 -45.3575 -27.512 +104 4 50.0955 6.63289 33.1892 -0.645528 -4.64769 17.8413 +105 4 47.8013 7.74388 33.6913 1.36166 0.224784 -7.99748 +106 4 47.0904 6.22572 33.1496 -13.2574 -0.904539 -3.87726 +107 4 49.004 7.98659 31.3992 -27.9616 -9.11626 3.58403 +108 4 47.1978 7.96127 31.27 -20.0009 14.5444 -5.73856 +109 4 47.5417 5.33248 30.4619 -18.467 18.3391 -3.45282 +110 4 49.1897 5.66674 30.5732 -8.59668 22.4275 -14.4147 +111 4 48.9982 7.27964 28.7313 27.9214 19.6218 -9.55881 +112 4 47.3685 7.40493 28.8518 27.8731 -11.8414 7.77703 +113 4 48.0065 6.08598 28.2169 17.275 11.5652 28.2934 +114 1 46.9206 5.03778 35.9702 10.3577 18.9682 5.15831 +115 2 45.6557 4.25932 36.0398 9.08885 -0.641191 -14.1305 +116 2 44.8836 4.39003 34.674 17.924 -7.95306 73.8288 +117 3 45.3111 5.13887 33.8455 4.25406 24.8458 -47.415 +118 4 46.9247 5.98842 36.4259 -8.42518 -21.6093 -9.66 +119 4 45.9322 3.16772 36.074 -4.07513 2.77881 8.35057 +120 2 44.7235 4.66099 37.2497 -7.79148 27.6424 25.8282 +121 3 44.4559 6.1146 37.2032 37.085 -18.356 15.5747 +122 2 45.2448 4.26963 38.7181 22.7861 29.0575 -8.8559 +123 4 43.727 4.13168 37.1283 17.3832 10.5512 -0.864114 +124 4 45.2761 6.59903 37.5183 -34.0557 -21.4787 -11.7364 +125 4 45.8733 4.97275 39.4014 -10.271 -7.81482 -36.7347 +126 4 45.822 3.36133 38.5799 14.1835 -15.9263 3.29814 +127 4 44.4672 3.97387 39.4102 -27.3329 -5.40347 3.37723 +128 1 43.7561 3.68722 34.6039 -10.1769 -38.5504 10.0379 +129 2 42.7898 3.65331 33.5354 16.9998 -6.12306 -24.86 +130 2 41.7694 4.78815 33.7404 2.26966 -0.410412 -51.1213 +131 3 41.2522 5.37284 32.7445 13.6537 -18.3748 18.9894 +132 4 43.5295 2.98811 35.3697 5.99608 22.1557 -16.865 +133 4 43.3523 3.94914 32.5036 -19.5402 -19.5629 37.0771 +134 2 42.0755 2.18627 33.4863 21.9074 34.2086 -29.4327 +135 2 42.9391 0.859767 33.721 -6.85443 30.257 35.6042 +136 2 42.2358 41.4668 33.4285 -9.81834 -3.65893 -31.5778 +137 2 44.2283 0.854864 32.9471 53.2312 13.9788 40.9195 +138 4 41.6117 2.20331 32.4686 -4.39523 -13.2201 2.61812 +139 4 41.2586 2.27352 34.2121 -10.6776 -10.6054 4.67488 +140 4 43.2056 0.83773 34.8124 -0.343624 1.56324 -2.51079 +141 4 42.8118 40.5237 33.3983 6.69029 -0.569008 16.3673 +142 4 41.9597 41.5484 32.3684 -17.7546 -2.75522 -9.07631 +143 4 41.3245 41.3357 34.0216 -8.62626 -3.98831 3.9624 +144 4 44.0827 0.853311 31.8896 -3.53557 -4.02089 -36.565 +145 4 44.8236 41.822 33.2847 -5.06735 25.2561 -15.1823 +146 4 44.8583 1.80877 33.1923 -14.5958 -31.7921 -4.90526 +147 1 41.5264 5.19611 34.9737 -24.8334 44.6246 6.63495 +148 2 40.6685 6.33721 35.2699 -7.96634 19.3021 -16.1623 +149 2 41.3876 7.74941 35.097 -11.5591 -21.8484 1.81155 +150 3 40.7047 8.75309 34.8417 -6.4948 4.14558 0.128999 +151 4 41.7654 4.68652 35.8013 13.1043 -20.8107 18.8359 +152 4 39.8731 6.44712 34.4383 10.8594 -11.0445 14.3032 +153 2 39.8592 6.12601 36.6093 -15.5564 -7.24317 -37.5678 +154 3 40.7443 5.88444 37.6633 23.6025 16.5055 19.3857 +155 2 38.9047 4.85477 36.5395 -12.0583 61.1722 12.675 +156 4 39.322 7.07341 36.7706 -11.99 4.52079 9.89046 +157 4 41.1265 6.74598 37.8781 -3.93551 -10.4676 -4.79928 +158 4 38.0585 4.98564 35.7954 18.0693 -6.53498 -0.435941 +159 4 38.3566 4.77654 37.5171 8.14363 -6.92414 -3.72239 +160 4 39.543 3.99696 36.3828 0.165947 -30.6128 -6.86199 +161 1 42.7342 7.80416 35.136 -13.9315 11.8694 11.7976 +162 2 43.5142 9.02936 34.9481 17.7181 -46.9691 35.2138 +163 2 44.5073 9.42999 36.0349 -55.8537 -50.7646 50.0035 +164 3 45.375 10.2125 35.7599 43.422 25.9365 -4.74067 +165 4 43.1984 6.94617 35.4338 19.599 0.647333 4.29925 +166 4 44.1406 8.86955 34.0842 9.16679 3.97336 -28.1373 +167 4 42.9197 9.91228 34.8204 -18.5221 19.1219 -12.9063 +168 1 44.2798 8.93745 37.3587 -4.0043 10.1489 -58.0949 +169 2 45.1948 9.27519 38.4238 -4.17993 36.3676 -26.0855 +170 2 46.5575 8.73344 38.0061 12.5522 -20.4469 18.6928 +171 3 46.7331 7.49794 37.7681 -6.88831 31.8582 -6.20611 +172 4 43.377 8.45873 37.5311 9.37776 2.67644 11.4724 +173 4 45.2318 10.4158 38.3238 5.33405 -13.6354 14.6161 +174 2 44.7823 8.84756 39.8415 35.39 -32.4267 -9.44324 +175 2 45.5211 9.64049 40.9405 -33.0234 -16.4934 27.578 +176 2 45.0293 11.1067 41.0295 26.955 13.1382 1.75579 +177 2 45.9939 11.883 0.056845 5.44769 -3.52142 -7.77113 +178 1 45.567 13.2463 0.389189 -21.8942 22.5552 58.7427 +179 4 44.9649 7.71121 39.9163 -1.68078 22.7299 4.94117 +180 4 43.7292 8.96914 40.0006 -34.3585 3.91778 0.788359 +181 4 46.6326 9.56148 40.8729 -4.12637 -0.755434 -1.7729 +182 4 45.1589 9.15652 0.052119 21.5355 9.01144 -26.2886 +183 4 44.0384 11.1525 41.4882 -17.6691 -1.8484 1.78047 +184 4 44.9645 11.6456 40.0488 1.32443 -5.52779 3.51863 +185 4 46.9936 12.0079 41.4163 -11.0521 -7.71607 17.8496 +186 4 46.0863 11.2417 1.01939 6.64185 25.7549 -16.0759 +187 4 45.6176 13.9315 41.5535 6.39074 -1.54943 -2.93714 +188 4 46.1207 13.6426 1.21669 -15.3499 -18.2055 -38.2327 +189 4 44.572 13.3465 0.725918 28.6554 -12.4083 -12.8179 +190 1 47.5723 9.62675 38.0225 1.62241 16.525 -13.2778 +191 2 48.9413 9.31976 37.6447 28.3505 6.17866 3.85392 +192 2 49.7947 9.65595 38.897 -51.2415 76.6103 -24.0977 +193 3 49.6063 10.7902 39.4401 12.9093 -42.4425 -12.577 +194 4 47.4538 10.6389 38.3066 -1.81401 -22.4625 -4.08398 +195 4 49.0905 8.23756 37.4201 -8.03606 -0.867672 -0.903629 +196 2 49.3577 10.1392 36.3514 -15.5639 -8.86216 -34.5575 +197 3 48.3381 9.84531 35.2995 20.2521 4.60838 26.9691 +198 2 50.6821 9.73379 35.6575 -13.1705 -1.52152 26.2758 +199 4 49.443 11.2403 36.5183 -14.2645 -0.263993 8.70321 +200 4 47.5106 10.2398 35.5579 0.218555 2.62212 3.26783 +201 4 50.9323 10.3465 34.7687 -2.88514 -3.55444 -7.60949 +202 4 50.7732 8.65192 35.4951 -3.14548 -9.24106 -12.1943 +203 4 51.4763 9.94768 36.3674 17.1427 5.0591 10.0517 +204 1 50.5022 8.69828 39.4305 24.0939 -43.466 77.1583 +205 2 51.0483 8.71922 40.8082 -0.802123 10.2433 -32.8315 +206 2 52.5183 8.33859 40.7231 46.1376 25.1574 58.8821 +207 3 52.8914 7.33748 40.1143 13.0446 10.4001 -14.6089 +208 4 50.6189 7.73433 39.1341 -5.48208 -8.91176 -29.3848 +209 4 51.0045 9.75097 41.1725 -0.547397 17.2241 4.09797 +210 2 50.2922 7.85282 41.8455 19.6626 -50.7873 -7.63422 +211 2 50.2811 6.29504 41.471 -17.2864 -17.6708 26.7503 +212 2 48.8668 8.31684 0.212195 -17.3783 63.506 12.4232 +213 2 49.3691 5.38294 0.512646 14.3884 65.6628 -4.02696 +214 4 50.9326 7.9114 0.860642 -12.3241 5.1929 3.57402 +215 4 51.3127 5.83882 41.5287 -4.74499 10.5855 -5.5164 +216 4 49.8921 6.13652 40.4532 1.6457 0.843055 -11.9856 +217 4 48.0317 8.06123 41.424 13.0217 -7.20036 -2.54126 +218 4 48.8693 9.49201 0.254246 -0.917701 -32.4673 -2.46528 +219 4 48.5263 8.05212 1.23597 1.41612 -6.96817 -0.649274 +220 4 48.2816 5.57755 0.309314 6.34191 -1.32326 5.14384 +221 4 49.6363 5.72968 1.56057 -11.1106 -15.1353 -5.99489 +222 4 49.54 4.32324 0.397743 7.27301 -24.1582 -2.3836 +223 1 53.3925 9.14738 41.5454 -19.7766 -15.6836 -47.6014 +224 2 54.8543 9.29866 41.641 -12.5045 -20.0873 29.727 +225 2 0.407838 8.25913 0.762984 -29.7207 32.5524 -37.8245 +226 3 54.8643 8.2564 1.86493 17.0269 -29.0845 20.332 +227 4 52.9285 9.69819 0.341812 -9.11605 14.2566 13.2302 +228 4 0.291486 9.0623 40.6877 9.99865 -5.39191 -34.8298 +229 2 0.359683 10.7121 0.203065 -6.90664 -3.88067 -14.6485 +230 3 54.4765 11.8025 41.752 -11.2022 -21.2627 -5.88002 +231 2 1.6614 11.1001 41.4135 2.5167 -27.9916 -13.3179 +232 4 0.487415 10.6137 1.28953 0.410521 18.1219 13.0764 +233 4 54.0953 12.1937 0.613553 1.59003 1.59721 11.7532 +234 4 1.92456 12.0955 41.7398 14.8193 23.7252 4.53742 +235 4 1.52762 11.126 40.2979 3.61624 1.93597 7.36374 +236 4 2.5241 10.4069 41.6364 -8.38015 7.04993 1.52106 +237 1 1.45864 7.53391 0.367476 0.545631 9.71791 -21.8799 +238 2 2.25081 6.65311 1.15507 26.446 -0.0641839 -18.4938 +239 2 3.7671 6.96757 0.917085 -57.4365 -22.4689 85.9929 +240 3 4.15047 7.41488 41.7757 21.4144 12.1214 -29.7802 +241 4 1.8001 7.62601 41.3064 3.76941 -0.348546 3.21752 +242 4 1.98413 6.84865 2.19976 1.77378 -4.57114 13.3572 +243 2 1.98593 5.20856 0.673411 -39.0557 8.05152 -2.47083 +244 2 0.499001 4.77546 0.950638 51.92 -35.3278 3.54994 +245 2 0.302449 3.38226 0.307039 12.2804 5.92691 27.6936 +246 2 0.318833 4.59091 2.46762 -57.1886 17.9845 23.4913 +247 4 2.62035 4.47984 1.15306 24.0478 -12.5257 10.4353 +248 4 2.17019 5.14075 41.4887 6.74012 -0.473312 -2.7006 +249 4 54.8482 5.46061 0.448133 -33.0903 28.7369 -7.07308 +250 4 54.2241 3.15851 0.337643 -14.6094 -12.7265 -2.24176 +251 4 0.881511 2.58656 0.876485 -8.96903 11.0382 -11.5819 +252 4 0.635114 3.38296 41.1822 2.70741 -4.49002 -20.1461 +253 4 0.991181 3.80938 2.86091 2.53728 -4.51346 7.06316 +254 4 54.1796 4.30541 2.72425 38.6722 3.44969 -10.622 +255 4 0.495432 5.52724 3.08531 2.73328 -11.7655 -13.2166 +256 1 4.49387 6.66874 2.05101 59.25 35.5651 -63.8633 +257 2 5.97745 6.82619 2.08157 -13.5783 -40.6566 -15.6714 +258 2 6.57448 5.47381 2.54294 67.6927 12.9151 50.3283 +259 3 7.53922 5.43765 3.33186 -5.78511 6.85237 -12.8739 +260 4 4.10191 6.33546 2.9164 -11.2688 -10.0369 11.6191 +261 4 6.35409 6.85375 1.02753 1.73229 12.3732 3.55997 +262 2 6.47001 8.00523 2.96248 -35.1701 -2.47648 -9.01657 +263 2 6.52316 9.38515 2.26526 -52.089 -36.3571 -52.5381 +264 2 6.66039 10.5311 3.17647 23.2175 30.5211 32.7092 +265 3 7.81872 10.9467 3.49478 5.10838 -9.19539 -6.96115 +266 3 5.64173 11.0573 3.6767 -20.5888 -1.64097 0.158765 +267 4 7.42654 7.87231 3.41702 35.4584 -16.2138 5.63399 +268 4 5.81838 7.86205 3.84167 -4.54492 27.3919 10.2645 +269 4 5.56237 9.49095 1.59664 20.5708 1.89307 25.306 +270 4 7.29681 9.38215 1.47849 13.2355 1.21078 1.19218 +271 1 6.08096 4.31767 2.17259 -39.414 -15.8224 -24.7678 +272 2 6.39518 2.91476 2.36043 4.12081 37.0723 19.1814 +273 2 7.75633 2.62628 1.79624 63.8838 -9.4865 -25.3011 +274 3 8.33634 3.36937 0.946953 -27.4154 -16.213 26.3787 +275 4 5.28658 4.43126 1.58002 -24.0887 -1.16266 -20.2566 +276 4 6.54455 2.77577 3.45017 -8.86613 -5.70482 8.60941 +277 2 5.25427 2.02933 1.82805 -30.6144 -48.6247 5.61864 +278 2 3.85552 2.1153 2.66383 78.486 27.413 32.1434 +279 2 4.87851 2.27508 0.297641 -10.4566 -15.7718 22.2154 +280 4 5.65998 0.937168 1.99721 -15.6319 23.5495 -14.0675 +281 4 3.98898 1.63213 3.72107 -1.04911 23.3354 -24.3429 +282 4 3.15409 1.48884 2.20213 -45.477 -24.0418 -26.2275 +283 4 3.51802 3.20813 2.70746 -2.40249 -20.6527 6.6832 +284 4 4.39172 3.24426 0.119355 -1.44384 9.21297 0.0772101 +285 4 4.19746 1.51559 41.6955 12.4172 8.09212 16.5491 +286 4 5.82002 2.28129 41.6778 17.5327 1.3005 -22.4945 +287 1 8.43941 1.53208 2.30673 1.7292 42.4201 -39.4356 +288 2 9.76672 1.10452 1.81012 11.995 -19.5667 23.3003 +289 2 9.60964 41.7637 0.921245 4.05677 21.7498 -11.1929 +290 3 8.59567 41.087 1.06007 7.18507 -15.5872 -8.58634 +291 4 7.90606 0.81761 2.76924 -8.42032 -19.931 16.3865 +292 4 10.4026 1.87877 1.34085 -18.5158 15.1062 -12.7744 +293 2 10.6232 0.647963 3.0246 -34.7832 -39.5023 14.4787 +294 2 11.0993 1.6812 4.04079 16.2934 16.5377 23.708 +295 2 12.4719 2.27616 3.59128 -46.8378 -2.52013 6.7155 +296 3 13.4675 1.63575 4.02276 22.0629 14.477 -13.463 +297 3 12.4471 3.24187 2.73298 15.8946 -22.2661 28.0778 +298 4 11.4641 0.045385 2.63277 10.8271 5.92943 5.75519 +299 4 10.0353 41.7446 3.607 8.35649 20.5438 -12.0897 +300 4 11.2832 1.11765 5.0427 -4.51453 13.9694 -21.6118 +301 4 10.341 2.4932 4.3105 9.65416 -13.2167 -8.7997 +302 1 10.6494 41.4676 0.039711 8.78515 0.440053 18.9323 +303 2 10.7217 40.2184 41.1909 10.2574 -28.5822 12.1248 +304 2 10.6889 38.8907 0.171469 -17.3791 70.2346 -13.2363 +305 3 10.1368 37.8928 41.652 0.864281 -20.5458 12.6113 +306 4 9.82473 40.2067 40.5786 -14.2689 -8.84554 -18.4029 +307 2 12.0478 40.1799 40.3262 -31.3786 20.6535 10.6233 +308 2 12.4388 41.6551 40.4794 16.223 20.8678 -10.392 +309 2 11.8805 0.34241 41.7792 -28.1233 -36.7072 -34.4959 +310 4 11.9102 39.8982 39.2292 -1.08614 0.893428 17.4874 +311 4 12.7409 39.4563 40.8087 9.93344 3.46544 -3.32375 +312 4 12.0845 0.391154 39.5895 8.62314 -16.2997 14.2071 +313 4 13.5502 41.7447 40.5643 -1.70925 0.910467 -12.4735 +314 4 11.7305 1.40344 41.6414 -9.5626 24.5309 -2.35213 +315 4 12.5687 0.26268 0.684216 19.8182 -9.73862 27.9097 +316 1 11.1854 39.0885 1.40191 34.1901 -11.3327 18.3686 +317 2 11.4785 38.09 2.41707 -37.5808 13.2867 4.32174 +318 2 10.2405 37.7763 3.3402 -0.155099 -13.1844 6.87934 +319 3 10.4378 36.9653 4.27207 -11.6928 9.67513 -22.7546 +320 4 11.6756 39.9703 1.62918 -8.97807 -2.58442 -2.36164 +321 4 11.7153 37.147 1.89269 -3.37493 -11.1801 -2.58831 +322 2 12.7263 38.4682 3.25859 -32.7454 -15.529 27.3397 +323 3 12.5885 39.7408 3.87129 1.54426 18.5893 -11.5354 +324 4 13.5945 38.4441 2.61946 23.9879 5.88222 -14.7576 +325 4 12.9197 37.685 4.04183 -3.566 10.9198 -2.82194 +326 4 11.9285 39.8531 4.57214 8.5625 -16.1459 -5.7164 +327 1 8.98961 38.3717 3.14779 19.3135 28.1448 -76.0315 +328 2 7.78009 38.1002 3.90315 -4.26896 22.0341 0.229441 +329 2 6.83069 37.1869 3.18241 -25.8564 -25.3069 -16.1867 +330 3 6.84398 36.9785 1.97125 20.9058 23.903 -13.4458 +331 4 8.79049 38.9506 2.20714 10.5577 -30.8167 54.9659 +332 4 8.11274 37.5073 4.75427 1.14536 -6.32615 23.8911 +333 2 7.0077 39.4163 4.32571 4.21253 -4.87986 18.678 +334 2 7.75781 40.1168 5.42156 46.58 -14.1846 12.934 +335 3 8.30143 41.2262 5.21331 -14.6188 11.6514 -5.86083 +336 3 8.10545 39.4797 6.46784 -18.045 3.20128 -4.6129 +337 4 6.01572 39.173 4.78754 -1.72287 0.045533 -10.2864 +338 4 6.87032 40.2048 3.55457 -4.98407 -10.6589 -12.5629 +339 1 5.91154 36.4899 3.88964 18.6928 -0.691686 25.3425 +340 2 4.98537 35.571 3.20749 -24.0931 31.8814 30.8723 +341 2 3.79198 36.4499 2.67545 58.5623 50.3783 54.6165 +342 3 3.60244 37.6478 3.05835 4.98938 -42.2114 -12.2812 +343 4 5.945 36.5545 4.93654 -10.5756 -4.83423 -16.3239 +344 4 5.5221 35.038 2.40161 -3.05594 2.46612 -11.4716 +345 2 4.40384 34.4728 4.15145 -1.70261 45.9252 5.92389 +346 3 3.98498 35.0725 5.41787 -8.00202 -46.5665 -16.5053 +347 2 5.48475 33.4747 4.46048 0.249803 -29.9924 71.6177 +348 4 3.54337 34.0389 3.61058 -6.82183 -12.9435 7.69028 +349 4 3.62675 34.2747 5.86698 6.39679 27.749 2.05336 +350 4 5.85279 32.9868 3.57629 11.3184 -16.9973 -22.3871 +351 4 5.09248 32.6743 5.23041 8.97186 17.4623 -32.7541 +352 4 6.34746 33.9006 5.03324 -0.476546 4.78606 -11.5797 +353 1 3.00152 35.8184 1.87366 -46.1462 -42.5584 -55.0681 +354 2 1.77021 36.3468 1.35692 -36.7765 14.163 11.1031 +355 2 0.721356 36.5788 2.57059 18.2386 -29.7925 23.2574 +356 3 54.9678 37.5551 2.63992 10.9193 3.0322 -8.68025 +357 4 3.31287 34.9586 1.40066 1.19836 -3.77239 4.28893 +358 4 2.05059 37.3327 0.922928 -11.4048 10.7741 9.22697 +359 2 1.07197 35.5705 0.158527 41.3495 -39.9506 -9.05678 +360 2 1.73776 35.9497 40.6674 -26.4234 39.8053 33.0301 +361 2 54.5322 35.7209 0.133627 -14.8072 -12.0564 -1.20894 +362 2 3.23928 35.9487 40.63 7.11928 -24.1756 -12.68 +363 4 1.32474 34.4514 0.269568 -7.211 20.0201 5.35532 +364 4 1.47926 37.0502 40.6385 -3.87579 -7.90549 -26.2729 +365 4 1.36122 35.3789 39.7771 -4.72819 3.84386 12.155 +366 4 54.087 35.0558 41.2526 3.68912 7.63158 3.17282 +367 4 54.2076 36.7772 41.8385 0.949253 -6.55132 4.09096 +368 4 54.0676 35.3362 1.10912 4.22691 12.456 -17.368 +369 4 3.57003 34.9443 40.8434 9.13412 -24.8126 8.40569 +370 4 3.78301 36.5792 41.3142 5.34684 18.5101 18.1918 +371 4 3.6567 36.127 39.6372 -0.20476 7.44967 -14.9904 +372 1 0.712989 35.6055 3.58431 38.0557 9.26554 -59.6495 +373 2 0.05279 35.6483 4.83915 -15.0961 2.42646 38.658 +374 2 0.191347 37.0144 5.48801 7.00468 33.8104 1.40802 +375 3 54.154 37.7008 5.76148 35.4113 -11.6645 -8.2681 +376 4 1.23482 34.733 3.35856 -11.2418 4.01634 10.8504 +377 4 53.9671 35.581 4.69172 -20.2496 -5.13772 -12.456 +378 2 0.463881 34.4895 5.81355 17.031 15.9659 -33.5139 +379 2 54.8083 34.3393 7.16558 -30.7527 -16.2072 -11.1445 +380 2 0.00712 35.4957 8.10271 3.59003 -8.69902 15.3198 +381 3 54.0967 36.3529 8.34542 -1.77732 -9.94333 -12.6544 +382 3 1.07192 35.4587 8.7399 35.3598 16.353 18.5034 +383 4 1.56574 34.5304 5.94519 0.590681 0.639559 4.32925 +384 4 0.280894 33.5741 5.23349 -1.52963 -16.3279 0.16603 +385 4 0.223173 33.3947 7.64873 -6.8885 8.42796 -3.46601 +386 4 53.7112 34.1554 6.97481 9.65493 -2.46487 7.60139 +387 1 1.50649 37.4152 5.65526 -22.458 -31.2308 -17.0045 +388 2 2.02438 38.6379 6.15097 -3.22056 29.1656 36.4104 +389 2 1.58588 39.8651 5.40701 -13.5031 20.9194 -76.104 +390 3 1.07209 40.8553 5.93778 8.03965 -15.1327 11.1864 +391 4 2.24702 36.741 5.38136 -6.00826 1.88497 2.51587 +392 4 1.72629 38.833 7.20228 -22.1923 -11.9073 0.0585309 +393 2 3.51949 38.6121 6.24971 43.6984 -50.5664 -0.0787057 +394 2 4.11017 39.7004 7.10642 -5.48661 12.2779 -12.8977 +395 3 4.55887 40.7033 6.57435 6.12607 11.2234 -5.55098 +396 1 3.97545 39.5562 8.42942 -13.6958 7.00999 41.6346 +397 4 3.92653 38.5973 5.19958 6.67843 9.43594 11.2804 +398 4 3.90699 37.6191 6.72902 -10.8805 23.4385 -12.7616 +399 4 3.35162 38.8096 8.83526 13.2612 9.60447 -6.60232 +400 4 4.25023 40.3377 9.09595 -2.56729 -20.1743 -21.9158 +401 1 1.64621 39.8034 3.99517 -50.1719 52.4074 67.8966 +402 2 0.960547 40.8538 3.14427 -3.37695 -31.9032 -17.009 +403 2 54.4047 41.0035 3.47138 71.1401 19.2662 2.3079 +404 3 53.9887 0.221409 3.63964 -22.8765 18.4333 9.81455 +405 4 2.07659 38.9926 3.63308 18.9969 -31.9912 -34.7926 +406 4 1.39808 41.8727 3.34889 0.835518 -9.01277 1.27119 +407 2 1.14841 40.4887 1.56595 -9.49555 20.2148 39.7014 +408 2 0.469253 41.6189 0.677094 10.8075 11.2475 47.495 +409 2 2.6528 40.4777 1.25625 -15.459 -47.3647 -39.6369 +410 4 0.776571 39.4398 1.40308 -11.1955 11.1351 -6.38222 +411 4 54.3852 41.8501 0.825468 -5.0709 -17.7069 -2.05205 +412 4 0.696071 41.5065 41.5456 0.0730393 -4.82529 -32.9133 +413 4 0.904174 0.691668 0.985463 6.30616 -9.41897 -5.2369 +414 4 2.64269 40.3122 0.13166 16.7998 18.1471 15.5753 +415 4 3.13789 39.5289 1.58622 -1.56816 4.1145 9.56394 +416 4 3.29805 41.2779 1.59825 6.1243 20.9887 1.16769 +417 1 53.684 39.9214 3.65257 -36.1976 13.6917 8.19643 +418 2 52.3006 39.9493 4.06589 -56.8626 -17.5359 -10.0305 +419 2 52.042 40.5256 5.46425 9.62461 10.2848 -5.14962 +420 3 51.0331 41.2228 5.70144 14.4944 -11.372 -4.23176 +421 4 54.0189 39.0607 3.30247 15.8062 -40.5534 -6.95561 +422 4 51.6931 40.6476 3.38276 19.0563 -8.07776 7.22418 +423 2 51.5622 38.4976 3.96193 14.5706 2.1127 21.5154 +424 2 51.4158 37.9814 2.50572 24.752 -20.928 -15.9835 +425 2 51.0077 36.4305 2.37064 11.3099 30.9145 9.08043 +426 2 50.8522 35.9939 0.907307 -46.4939 -7.09254 -49.7464 +427 1 50.1475 34.7025 0.671588 69.6077 -32.405 2.84717 +428 4 50.6006 38.4842 4.55016 3.73478 6.81079 -18.2086 +429 4 52.1831 37.7463 4.55262 -3.81101 12.3643 -13.1539 +430 4 52.4118 38.1657 2.02278 1.77015 -18.5404 7.48984 +431 4 50.8584 38.5927 1.79489 -26.3581 9.74254 8.34414 +432 4 50.0453 36.2246 2.88499 -2.56193 3.57961 3.68626 +433 4 51.7703 35.8375 2.92238 0.215708 -6.73604 -5.33103 +434 4 51.7691 36.0437 0.240386 -6.2594 -4.10885 19.6388 +435 4 50.1039 36.686 0.3716 22.9763 1.60597 16.3794 +436 4 50.5914 33.8993 1.10828 2.95648 12.8391 18.7814 +437 4 50.3001 34.3737 41.6268 -19.3387 19.3411 -4.27099 +438 4 49.2006 34.6111 0.961468 -24.084 7.88088 -0.582308 +439 1 53.0235 40.2561 6.35237 -32.3128 10.4579 -5.0201 +440 2 53.1129 40.7256 7.70074 -41.6363 -1.15369 57.3167 +441 2 53.1798 0.352689 7.77253 -34.9991 -20.8035 37.2736 +442 3 52.5119 1.01286 8.63006 21.7579 -17.6925 -30.8538 +443 4 53.6931 39.5673 6.06584 22.7894 -18.2937 1.39271 +444 4 52.0865 40.4844 8.3065 35.7608 3.68212 -29.1988 +445 2 54.2701 40.0034 8.46069 6.08948 28.5921 -6.02695 +446 4 54.5971 40.5153 9.39975 -22.234 -14.34 10.1754 +447 4 0.201561 40.2092 7.93116 13.6903 -2.08726 -21.3806 +448 4 54.1655 38.8939 8.41526 -0.559105 0.118215 15.5404 +449 1 53.9752 0.884949 6.87383 32.3465 35.364 -24.1241 +450 2 54.062 2.35993 6.75215 -1.13821 -0.709889 -34.8218 +451 2 52.7471 3.02097 6.14186 4.92946 35.4069 59.7439 +452 3 52.3227 4.16587 6.4978 18.9545 -33.4145 3.00952 +453 4 54.7345 0.266534 6.4753 -18.8262 24.4346 -1.05702 +454 4 54.2802 2.76759 7.79054 -12.1814 3.84369 -14.3249 +455 2 0.185451 2.81859 5.73187 27.2059 46.9588 30.4236 +456 2 1.71808 2.36893 6.1571 -63.9259 -20.0653 -29.4315 +457 2 1.9764 2.63004 7.63437 43.6306 13.7343 2.97159 +458 2 3.27263 1.81187 8.04275 -33.9139 -3.58936 -6.58926 +459 1 3.78328 2.11956 9.34176 26.6398 21.4152 24.507 +460 4 0.173809 4.01773 5.82442 4.54198 -39.0295 -6.50933 +461 4 54.8792 2.64498 4.65574 11.0791 -10.5686 10.592 +462 4 2.43618 2.90609 5.45978 -2.35628 -10.1976 10.4282 +463 4 1.76796 1.2289 6.01344 4.57023 21.5888 -8.89179 +464 4 1.21473 2.41369 8.37281 -19.449 -19.8593 5.28327 +465 4 2.02309 3.72579 7.75906 18.9296 5.96095 -1.30777 +466 4 4.11389 1.88412 7.33652 2.51142 0.584915 -8.00636 +467 4 2.91513 0.727469 8.06593 14.1612 11.4678 0.952909 +468 4 3.87966 1.33238 9.93849 2.65093 -23.7146 9.43734 +469 4 3.29203 2.7681 9.89323 -42.3935 13.6729 9.41431 +470 4 4.65765 2.6209 9.4154 12.4458 -11.5538 -21.8273 +471 1 52.0387 2.32512 5.28273 -51.3661 -11.8477 -11.6622 +472 2 50.6641 2.72274 4.84157 25.7857 6.93126 13.1254 +473 2 49.5414 2.57609 5.91007 27.6149 -7.37739 5.45836 +474 3 48.7805 3.52104 6.09585 -8.9672 -1.93713 4.87304 +475 4 52.4681 1.55108 4.79165 6.19099 -18.5603 -5.58783 +476 4 50.6769 3.82983 4.70864 1.41274 -1.50214 -10.3294 +477 2 50.3587 2.05695 3.49156 -22.4167 -18.5545 -8.10533 +478 2 51.392 2.35646 2.3419 -24.5199 12.8001 2.40788 +479 2 48.9327 2.41504 2.97856 -9.14079 -2.86031 26.3031 +480 2 51.1945 1.4129 1.15651 29.522 -13.6455 -15.5517 +481 4 50.3189 0.937191 3.7523 9.08136 15.4094 -11.3523 +482 4 52.3823 2.12188 2.68097 31.5971 -0.36407 15.4796 +483 4 51.4014 3.46798 2.06765 -1.078 -19.9026 -0.0406259 +484 4 48.2117 2.12758 3.78451 -1.04241 22.2186 2.00084 +485 4 48.5813 1.67256 2.28636 2.21501 -12.0529 -35.8697 +486 4 48.7327 3.44552 2.54328 5.48386 -12.5705 11.3103 +487 4 52.1623 1.3706 0.452926 -36.5132 5.61179 20.4585 +488 4 50.2881 1.70969 0.600596 -1.11419 -0.409473 -10.6314 +489 4 51.0211 0.353877 1.53511 3.53067 13.7442 -8.50616 +490 1 49.5623 1.51743 6.77214 29.0905 -0.0770965 -25.5222 +491 2 48.7084 1.41716 7.91723 -3.12505 -21.6463 4.96918 +492 2 48.8549 2.61932 8.82546 31.903 20.2748 29.0475 +493 3 47.906 3.05048 9.46897 -16.8524 2.35798 -10.3438 +494 4 50.2118 0.710522 6.59294 -12.9921 18.0739 4.61122 +495 4 47.6425 1.393 7.52359 9.91609 0.328738 10.372 +496 2 49.0787 0.089334 8.73016 -60.0302 -9.6098 -44.8862 +497 2 48.2852 41.7441 10.0242 3.18066 15.7764 -9.96769 +498 2 46.7826 0.060746 9.96682 -2.34726 -14.6607 41.7592 +499 3 46.2233 0.511631 10.9878 -5.96974 4.10403 -23.4495 +500 1 46.1388 41.3329 8.97776 32.9533 20.065 15.0282 +501 4 50.1182 0.035639 8.93296 42.8084 2.68407 12.3764 +502 4 48.8904 41.1121 8.0025 3.88899 17.9501 19.4277 +503 4 48.6104 0.602172 10.7954 4.73737 -18.8132 -0.914642 +504 4 48.4759 40.6816 10.3394 0.165969 9.19265 10.3013 +505 4 46.673 40.8953 8.25882 14.2049 -15.3063 -26.5369 +506 4 45.1569 41.364 8.91958 -49.0994 -2.53611 0.320683 +507 1 50.1114 3.13932 9.06291 -28.12 32.8195 0.337886 +508 2 50.3404 4.32895 9.98795 -1.65029 -57.226 -17.8628 +509 2 50.0322 5.66893 9.41362 -36.2334 -9.83443 -38.9072 +510 3 49.3598 6.44562 10.1062 15.3309 6.40082 -5.38514 +511 4 50.9085 2.84633 8.5071 12.3092 -10.0263 -3.45928 +512 4 49.5835 4.28149 10.7848 -3.38143 -13.253 14.1405 +513 2 51.7461 4.22789 10.5468 25.7206 14.4209 20.1557 +514 2 51.9023 5.17188 11.7283 -67.9962 -1.36338 64.1829 +515 3 50.9364 5.19004 12.6002 28.9599 1.18541 -41.9912 +516 3 52.9319 5.83594 11.9785 18.8411 2.87417 -24.5577 +517 4 52.4276 4.5214 9.72474 12.6887 -3.13287 0.413374 +518 4 52.058 3.21563 10.9647 -9.24198 7.66389 -16.6414 +519 1 50.112 5.78532 8.03139 7.52033 29.602 25.459 +520 2 49.6799 7.08933 7.40639 14.3534 -30.8181 22.5674 +521 2 48.2409 7.17209 6.9711 -2.24553 44.7474 7.57528 +522 3 47.5844 8.22961 7.08968 18.1939 -9.81929 5.41459 +523 4 50.7064 5.09112 7.53173 -12.638 14.3936 -6.22521 +524 4 49.7159 7.84119 8.19837 -7.36252 7.51614 21.2329 +525 2 50.7023 7.64954 6.44039 -16.0213 -40.4967 -48.4302 +526 2 50.7257 6.82423 5.08423 -13.7427 47.9405 2.4816 +527 2 51.6418 7.28287 3.94021 29.8472 39.248 73.299 +528 2 53.127 6.98483 4.24688 1.29977 19.7271 -18.9866 +529 1 53.757 7.95176 5.17575 -11.1866 13.844 -62.5277 +530 4 51.636 7.68275 6.97838 28.3767 1.23741 1.58475 +531 4 50.4129 8.66535 6.18803 -0.179632 23.7408 -3.11047 +532 4 49.7187 7.01043 4.64523 -5.97611 -10.1095 1.48316 +533 4 50.8061 5.7562 5.2149 3.4405 -22.8364 10.0865 +534 4 51.5118 8.41472 3.72654 -1.36136 -26.6124 -3.74792 +535 4 51.4228 6.66542 3.12568 -20.7249 -22.8033 -58.4365 +536 4 53.6095 7.03345 3.2004 3.85152 5.93338 28.8514 +537 4 53.3314 5.96083 4.57939 -0.112253 -9.13532 8.29834 +538 4 53.309 8.86524 5.1699 0.162268 -2.42959 1.84412 +539 4 54.6672 8.17057 4.81193 19.2107 -0.812718 7.6593 +540 4 53.869 7.69009 6.11536 0.991087 -15.435 33.6166 +541 1 47.7293 6.1299 6.36528 -13.6545 -50.1986 -45.913 +542 2 46.4151 6.11998 5.73127 12.5517 -4.35851 26.1033 +543 2 45.4457 5.24236 6.50095 -54.5114 -4.35957 -22.3583 +544 3 44.2134 5.34166 6.22856 33.5613 3.36987 15.344 +545 4 48.2957 5.29705 6.08439 -4.65701 16.0313 11.2062 +546 4 46.0246 7.14829 5.83676 -12.413 4.85954 -1.2939 +547 2 46.3966 5.7006 4.23247 16.9743 -35.0719 19.3242 +548 2 46.8471 6.79722 3.31369 7.95245 13.9142 -51.9109 +549 2 46.0679 8.12855 3.29075 19.7668 12.2354 20.4517 +550 3 44.9703 8.28242 2.6836 -5.20426 -7.76074 -7.99938 +551 3 46.5716 9.08042 3.9624 -5.49585 -3.27174 -8.75295 +552 4 45.3525 5.37075 3.98324 7.30106 1.55378 -6.68576 +553 4 47.1483 4.79199 4.10624 -28.8106 21.423 0.303262 +554 4 47.0017 6.41037 2.24023 -12.0684 6.13088 18.9752 +555 4 47.8815 7.05675 3.60692 6.175 4.12296 2.89493 +556 1 45.8802 4.28795 7.34048 -32.7588 9.8199 -6.22093 +557 2 44.9801 3.41661 8.05582 7.11941 -0.762777 6.83491 +558 2 44.2841 2.32798 7.24802 57.2007 25.2815 -35.4523 +559 3 43.4338 1.62321 7.71908 -38.784 -24.7635 26.1598 +560 4 46.8556 4.13399 7.46211 34.7056 -9.13536 7.69054 +561 4 45.5867 2.90913 8.82837 -2.10841 -5.06197 5.41207 +562 4 44.2233 4.00883 8.63057 1.71074 -0.990438 -6.10924 +563 1 44.7516 2.08483 5.98824 -37.8462 -38.4135 -8.16449 +564 2 44.1597 1.01431 5.13579 -9.65639 -34.378 14.28 +565 2 44.8664 41.5016 5.49089 -11.1964 37.9598 3.64882 +566 3 46.103 41.4369 5.57345 -11.1149 2.47206 2.88353 +567 4 45.5262 2.474 5.47152 21.0389 22.2918 12.8005 +568 4 43.0172 0.862184 5.40503 31.5022 14.6416 -15.142 +569 2 44.4162 1.4085 3.60515 5.8653 -21.2021 14.2009 +570 2 43.5161 2.65984 3.27425 41.0117 -18.0627 24.5931 +571 2 44.2213 0.116838 2.67583 -30.001 3.65408 12.6342 +572 2 43.604 3.10049 1.82796 -41.0466 14.5447 22.3036 +573 4 45.4923 1.71966 3.57573 -0.138156 -3.02814 -11.6903 +574 4 43.8008 3.50537 3.97163 -2.46499 -4.10631 -11.566 +575 4 42.524 2.38704 3.60859 -29.3388 -0.685173 -5.23931 +576 4 44.5714 0.285197 1.65031 -2.2735 9.46305 -11.1841 +577 4 43.1006 41.7553 2.65834 21.2852 6.7215 -5.00379 +578 4 44.7366 41.0658 2.93547 0.768749 11.7185 9.28335 +579 4 44.5004 3.68719 1.60884 14.6444 -0.878149 -7.94907 +580 4 42.7371 3.8089 1.73084 7.8177 -0.664582 -10.9353 +581 4 43.3892 2.25631 1.16493 5.07933 -5.28874 -15.8541 +582 1 44.0858 40.4147 5.76991 -7.82686 10.7063 0.0613705 +583 2 44.6952 39.2248 6.26612 46.8291 -49.1328 2.55503 +584 2 45.6273 38.4983 5.15014 -10.8203 -24.5871 -10.3389 +585 3 45.1671 38.1033 4.04814 1.93862 22.6196 32.2907 +586 4 45.3114 39.4262 7.20071 -5.62912 7.00222 -16.0196 +587 2 43.5561 38.2867 6.74046 -22.632 -0.869913 -14.9675 +588 2 42.367 38.8131 5.80069 8.99216 14.1028 58.1483 +589 2 42.6345 40.3137 5.92605 0.476166 33.3948 28.8915 +590 4 43.357 38.4284 7.8368 -6.62566 13.9326 -12.0425 +591 4 43.8048 37.1922 6.7609 -3.60965 9.48681 -21.6917 +592 4 41.3136 38.6254 6.13023 8.266 -9.51845 1.65532 +593 4 42.4187 38.6156 4.74928 6.70678 -23.3061 -29.6074 +594 4 42.2773 40.816 6.98347 15.1971 -23.3227 -46.4987 +595 4 42.1119 40.8277 5.08767 -3.55372 4.4917 2.49103 +596 1 46.8487 37.9967 5.55394 17.2019 12.2692 25.006 +597 2 47.7247 37.0178 4.87762 -6.21972 -16.2302 -28.9734 +598 2 47.0354 35.8358 4.10675 -5.54108 30.4574 49.2069 +599 3 47.4638 35.4602 3.01706 -3.2731 6.26074 0.626287 +600 4 48.411 37.4477 4.12082 -11.0175 18.1135 -5.68521 +601 2 48.6499 36.5231 5.98749 -16.6595 -15.0747 15.7963 +602 2 48.891 37.7945 6.79307 0.637735 -25.9659 35.4869 +603 2 47.512 38.4108 6.81936 -6.06228 0.364124 -35.7901 +604 4 49.55 36.0027 5.64818 14.2665 0.926908 -8.4052 +605 4 48.1323 35.7432 6.6035 -1.04051 5.39171 0.916503 +606 4 49.6303 38.4539 6.33816 11.9938 9.28906 -4.17289 +607 4 49.2156 37.5316 7.87598 -0.828426 8.45001 -24.626 +608 4 47.6223 39.5002 6.92189 -5.61966 10.135 -2.25063 +609 4 46.9349 38.0418 7.65693 -11.0214 -6.34351 22.8142 +610 1 45.9811 35.3016 4.79343 19.1712 31.3513 11.165 +611 2 45.3118 34.1769 4.28537 -21.2148 -46.3229 -17.5718 +612 2 44.4751 34.4561 3.06273 -18.3812 8.00009 -33.6438 +613 3 44.391 33.6426 2.09905 3.94034 16.0457 30.0851 +614 4 45.6176 35.6832 5.71813 13.2063 -8.66839 -22.6288 +615 4 46.0373 33.4799 3.80083 11.0255 -0.404913 12.3267 +616 2 44.604 33.4055 5.40679 37.9095 -5.49339 -20.8443 +617 2 43.894 32.1911 4.95963 4.52806 -52.0805 -10.2655 +618 3 42.6666 32.0496 5.30411 26.1406 -7.63566 -17.5185 +619 3 44.6473 31.2926 4.419 -30.7677 19.4747 14.2469 +620 4 43.8381 33.9821 5.82617 -35.1808 40.951 30.2942 +621 4 45.3664 33.1691 6.19311 -10.275 -1.0365 4.4818 +622 1 43.9409 35.7078 2.94042 3.22733 -51.5357 -49.9186 +623 2 43.348 36.2006 1.70588 25.8776 -9.12573 -18.8138 +624 2 44.3757 36.8172 0.713167 -7.64912 -13.2689 38.6134 +625 3 44.0628 36.9589 41.4508 -2.41529 3.02373 -15.0868 +626 4 43.9087 36.323 3.69682 4.46748 41.5024 48.5675 +627 4 43.0059 35.3045 1.0879 -7.34341 13.0696 15.3539 +628 2 42.2218 37.2049 1.98307 -32.8685 -0.904888 11.5727 +629 2 41.1062 36.5938 2.90711 22.5622 20.6064 -2.77479 +630 2 39.8757 37.4913 2.92488 9.99264 -5.47282 62.3883 +631 3 39.5847 37.9927 4.02645 -6.88693 1.84466 -13.34 +632 1 39.0832 37.5519 1.86835 -2.09978 -20.426 -31.5908 +633 4 41.7044 37.4782 1.02484 10.2081 4.13789 1.30545 +634 4 42.5649 38.1527 2.49808 3.34998 -7.04672 -12.996 +635 4 41.496 36.4873 3.97615 -8.32458 2.86238 -16.0656 +636 4 40.817 35.592 2.59085 -6.50381 -15.3028 -7.15704 +637 4 39.3467 37.1489 0.943045 -1.18671 2.30285 11.2704 +638 4 38.1024 37.7997 2.00291 -4.61511 13.1634 -1.5169 +639 1 45.5865 37.1913 1.18701 0.34656 3.48246 -50.9957 +640 2 46.5715 37.7193 0.263736 40.0587 13.4866 27.3297 +641 2 47.1476 36.6709 41.2495 -9.99518 -39.8037 -22.9547 +642 3 47.6611 35.6473 41.7682 -3.12622 19.3551 -24.5438 +643 4 45.9505 37.0475 2.10099 0.0710674 -6.02767 36.3056 +644 4 46.0766 38.4733 41.5789 -9.05589 19.6465 -18.4972 +645 2 47.8462 38.4064 1.04164 -24.5048 14.2529 -26.5929 +646 2 47.4036 39.6651 1.82888 -3.7708 6.53308 31.1421 +647 2 48.5926 40.4064 2.51341 13.2626 3.99863 -2.76696 +648 3 49.7104 40.5691 1.98441 -24.6046 -10.5895 -1.86534 +649 1 48.3407 40.8898 3.74779 29.4138 -3.81739 16.8938 +650 4 48.597 38.7482 0.246377 -8.81496 -5.86425 14.2737 +651 4 48.3893 37.7509 1.72975 1.66752 -15.4435 3.74234 +652 4 46.6019 39.4971 2.66308 23.3117 -7.11271 -27.0857 +653 4 46.9261 40.3559 1.12913 -3.21242 13.4997 -7.95635 +654 4 47.3907 40.9351 4.12169 -5.60594 2.69026 7.41827 +655 4 49.1659 41.1473 4.37984 -25.8317 -2.18268 -20.985 +656 1 47.0143 36.8241 39.8589 2.94896 -6.17569 33.9376 +657 2 47.6738 36.0506 38.8108 16.6825 -23.5637 34.6067 +658 2 48.454 37.0258 37.9695 9.24498 -19.2444 17.2828 +659 3 47.9734 37.5867 37.0249 -16.9661 22.5794 -32.933 +660 4 46.3407 37.4883 39.4677 -2.13376 9.43233 0.449621 +661 4 48.4374 35.3321 39.3605 -24.6855 17.1776 -23.0678 +662 2 46.6968 35.2528 37.909 -27.9143 -33.2437 25.7199 +663 2 46.039 33.9895 38.7043 9.93401 10.5983 7.56799 +664 2 46.87 32.6784 38.9289 23.0786 -0.450758 -24.5995 +665 1 47.7656 32.5928 40.0651 -0.0346617 67.7235 50.2506 +666 2 48.5337 31.5574 40.3699 -14.5633 -26.8579 -35.9878 +667 1 48.7282 30.552 39.4879 -2.05986 8.25564 18.106 +668 1 48.8872 31.3858 41.6213 -4.84512 27.348 -3.11289 +669 4 47.2327 34.8627 37.0058 -5.81127 5.13112 -1.60937 +670 4 45.8267 35.9464 37.6192 18.3744 -10.9215 -5.83414 +671 4 45.065 33.6697 38.178 15.3305 12.1509 10.6411 +672 4 45.8045 34.3704 39.7428 -14.1926 -3.74807 -10.9265 +673 4 47.5159 32.4832 38.0006 -21.4463 1.51143 8.96621 +674 4 46.1858 31.8178 39.0967 -9.12823 -0.449275 -15.1225 +675 4 47.7485 33.3794 40.8208 -8.02877 -26.8637 -33.9869 +676 4 48.3609 30.5297 38.5261 -2.43008 2.66571 1.08755 +677 4 49.1746 29.6933 39.8011 5.57148 -11.3344 1.43527 +678 4 48.5595 32.0107 0.447997 -4.49593 6.14729 8.57279 +679 4 49.3675 30.5632 41.8859 20.5825 -37.41 17.1512 +680 1 49.6971 37.2567 38.3612 38.8031 36.8466 -19.9315 +681 2 50.6251 38.1764 37.6375 5.59701 -6.58181 11.8605 +682 2 51.1059 37.476 36.33 -5.39593 -3.52342 3.95062 +683 3 51.4567 36.2851 36.3473 -6.1727 9.88097 2.62067 +684 4 50.1666 36.6257 38.9842 10.5469 -17.0261 18.2142 +685 4 50.0436 39.1015 37.4003 1.48542 -2.85918 -9.88003 +686 2 51.8783 38.6033 38.5414 -14.1699 17.2606 4.5582 +687 2 51.4771 39.4948 39.8067 23.634 -8.13025 9.13717 +688 2 52.8025 39.6936 40.6861 -45.72 0.0787629 30.9804 +689 2 51.0312 40.8873 39.3543 -1.21924 6.71403 17.5275 +690 4 52.6247 39.2003 37.9187 -12.0326 -10.2321 5.24388 +691 4 52.4336 37.7304 38.9418 -1.83231 -8.6555 -7.07863 +692 4 50.6844 38.9864 40.4458 6.67436 6.37453 -9.78056 +693 4 52.9275 38.7652 41.2899 1.57503 4.15297 5.5095 +694 4 52.875 40.6185 41.4124 -9.95772 -27.9304 -22.9777 +695 4 53.6477 39.6981 40.0479 39.2622 9.27083 -23.1198 +696 4 51.882 41.4315 38.8764 -8.78739 -1.58992 -12.4168 +697 4 50.8284 41.5065 40.2813 -10.0843 -5.65437 -12.2377 +698 4 50.1041 40.7893 38.7156 9.84678 12.7352 4.22225 +699 1 51.1335 38.2092 35.1872 23.4477 43.7196 -18.1994 +700 2 51.5372 37.7272 33.8205 5.66277 23.826 53.2621 +701 2 52.816 38.5373 33.39 -13.9696 27.2523 3.91394 +702 3 52.9014 39.7954 33.5824 -9.48934 -35.8428 -1.88315 +703 4 51.0917 39.2914 35.1751 -6.07189 -44.7564 8.7296 +704 4 51.807 36.6734 33.9114 3.67702 -17.8942 -3.77347 +705 2 50.2728 37.942 32.9627 24.5619 2.20768 -27.072 +706 2 49.0946 37.0552 33.3907 -40.4332 32.861 4.12747 +707 2 50.6582 37.6771 31.4819 -4.87136 -12.6088 -15.1928 +708 2 49.1924 35.592 33.2496 18.605 -47.1891 -10.6734 +709 4 50.0222 39.0181 33.0462 -10.0421 3.96713 0.824793 +710 4 48.1822 37.369 32.7965 11.3859 0.507389 5.43773 +711 4 48.766 37.227 34.4352 6.35082 10.8857 5.72377 +712 4 49.7261 37.457 30.8365 21.3715 9.42576 10.5226 +713 4 51.3528 36.7896 31.3856 -11.4398 6.26312 1.5823 +714 4 51.2274 38.5516 31.0485 -10.0605 -6.0953 1.35419 +715 4 50.1827 35.2313 33.6939 -19.2762 -1.86106 -7.31237 +716 4 49.1345 35.3223 32.1629 6.46074 -3.78635 4.92713 +717 4 48.3248 35.0641 33.7333 8.66481 1.90115 0.669024 +718 1 53.7674 37.8522 32.7049 -0.401058 29.0536 2.76503 +719 2 54.8534 38.494 31.9889 21.3589 25.2573 -50.7784 +720 2 0.070256 37.9331 30.5159 -12.6617 -10.513 26.1463 +721 3 0.610536 36.8336 30.3273 -13.153 9.14635 -3.0322 +722 4 53.7049 36.8532 32.6778 5.78014 -33.2974 -6.55066 +723 4 54.4976 39.583 31.7137 12.734 -24.0185 30.659 +724 2 1.32523 38.4582 32.6174 -11.2306 -14.0383 43.8112 +725 2 2.25298 39.4244 31.93 21.239 -3.52493 -6.53852 +726 2 1.82142 40.7594 31.946 9.01925 8.15494 1.3639 +727 2 3.55305 39.1373 31.3858 -52.1121 -37.4601 32.7366 +728 2 2.62719 41.7738 31.436 16.1375 42.966 -9.20235 +729 2 4.2717 40.1621 30.8907 55.019 31.5071 -38.7093 +730 2 3.8753 41.5182 30.8618 10.3374 -30.1635 6.5347 +731 4 1.72137 37.3957 32.6071 -2.968 13.2806 -7.3675 +732 4 1.36361 38.7573 33.7485 -10.0277 -6.08615 -32.1159 +733 4 0.900203 41.04 32.4671 -4.90014 4.47018 0.827909 +734 4 4.05865 38.1292 31.3848 -19.507 10.3261 2.47632 +735 4 2.40669 0.963664 31.507 -12.4107 -17.8541 2.52862 +736 4 5.22734 39.8163 30.4261 -2.17835 18.3508 4.41679 +737 4 4.61313 0.382875 30.4956 -18.9116 -9.53382 4.9162 +738 1 54.5208 38.7001 29.536 -17.794 9.59417 2.44526 +739 2 54.4433 38.3677 28.0932 0.413701 6.77287 11.8816 +740 2 53.8236 36.9714 27.8054 -10.5704 38.9519 24.3324 +741 3 54.2836 36.1684 27.0139 12.3723 -16.7122 -9.38408 +742 4 54.0063 39.582 29.8758 15.9225 -27.1932 -25.0825 +743 4 53.6617 39.0994 27.7122 21.1252 -9.31914 -10.5745 +744 2 0.84771 38.4562 27.3872 5.21129 26.4327 0.415045 +745 4 1.55752 39.2926 27.6564 -22.375 -0.429945 3.27523 +746 4 0.737328 38.5366 26.268 -0.662808 -7.52676 8.67249 +747 4 1.44048 37.5755 27.6711 3.3074 -14.1434 -6.0421 +748 1 52.6712 36.7812 28.4639 -34.4859 10.4254 42.9936 +749 2 51.8461 35.5981 28.5315 7.11639 -32.3641 19.2856 +750 2 52.1287 34.6607 29.761 72.1729 37.4894 -16.6197 +751 3 51.2969 33.8912 30.1393 -37.38 -39.1809 16.7772 +752 4 52.2301 37.5459 29.0797 18.7619 -22.9106 -24.882 +753 4 50.752 35.8045 28.6381 6.6344 10.4547 -3.03351 +754 4 51.9318 34.9661 27.6028 3.27123 7.03186 8.45077 +755 1 53.4041 34.6064 30.3039 -37.1524 -18.2668 23.7743 +756 2 53.8481 33.579 31.3343 19.9058 12.4048 -28.9308 +757 2 53.2753 33.7631 32.7245 -4.20442 17.2631 -10.7202 +758 3 53.3264 34.8931 33.2388 -7.00143 -11.8952 2.65621 +759 4 53.9984 35.4233 30.2821 14.046 11.4873 -9.55867 +760 4 53.5575 32.5679 30.9796 -2.97426 -3.20006 -4.3618 +761 2 0.441949 33.6673 31.397 15.483 24.485 -22.5221 +762 2 1.1159 33.1056 30.111 -2.52249 -22.0361 -11.2405 +763 2 2.65939 33.3504 30.0471 -29.7948 -11.8394 -36.8606 +764 2 3.5253 32.433 30.8659 3.71436 3.74322 35.9681 +765 1 4.92891 32.7835 30.8601 -3.73949 -14.6782 3.94495 +766 4 0.930008 33.1164 32.2052 -10.1795 -8.12889 21.2637 +767 4 0.820281 34.7554 31.5264 -17.1946 -20.5931 1.67355 +768 4 0.726808 33.5631 29.1693 -8.69229 5.5421 6.41341 +769 4 0.816642 32.0044 30.0112 14.0154 14.8269 0.94841 +770 4 2.76655 34.4177 30.2798 16.9839 11.3836 1.64388 +771 4 2.99027 33.2006 28.9712 -4.31169 8.16855 10.4317 +772 4 3.48024 31.3628 30.6286 -9.21502 -9.13385 -9.88849 +773 4 3.14214 32.5157 31.9169 10.307 -3.37241 -3.01155 +774 4 5.38024 32.7641 29.968 4.13535 -6.65161 -12.8027 +775 4 5.44585 32.16 31.4735 7.57437 4.94374 1.68638 +776 4 5.11721 33.7072 31.1652 -0.520286 24.3887 13.7994 +777 1 52.7286 32.6609 33.3217 21.3895 7.82715 -40.48 +778 2 52.3746 32.6765 34.6845 -3.94215 -5.7204 42.1903 +779 2 53.6544 32.9612 35.4718 -32.0777 16.7216 -3.31611 +780 3 54.7101 32.4293 35.2196 26.5529 -12.799 -1.69002 +781 4 52.7346 31.7402 32.8358 -3.66087 10.5856 2.03104 +782 4 51.6553 33.4893 34.886 -4.93781 11.2662 -7.45083 +783 2 51.7389 31.3462 35.1425 36.1525 -8.24878 -2.45066 +784 2 50.4549 31.4357 35.902 -2.56298 9.46411 57.003 +785 2 50.5914 31.9702 37.3969 -4.77582 -10.2539 -35.2763 +786 3 49.9129 32.941 37.7385 4.53321 10.1718 7.36032 +787 1 51.4448 31.3274 38.2318 1.89331 10.2207 20.9211 +788 4 52.4532 30.7011 35.7138 0.934865 4.72627 -2.3237 +789 4 51.5619 30.7887 34.2312 -11.1921 -21.1455 -14.7508 +790 4 50.0197 30.4197 36.0127 -8.03636 -0.273264 -6.56567 +791 4 49.7685 32.1089 35.3545 -11.9583 -2.57651 0.31815 +792 4 51.7323 30.3416 38.1022 2.22495 5.18328 -8.30147 +793 4 51.645 31.7871 39.1631 -4.2657 -12.8631 -21.1898 +794 1 53.54 33.8952 36.4131 -39.2018 -0.531466 -0.79929 +795 2 54.5682 34.2648 37.3102 -29.3437 58.7358 21.9421 +796 2 54.3255 33.5954 38.6431 29.6978 -77.406 0.637438 +797 3 53.3742 33.7807 39.3881 -15.8118 22.9548 5.85491 +798 4 52.6165 34.3686 36.5483 14.9252 -1.63515 2.31459 +799 4 0.525104 33.9954 36.8979 32.3496 -27.0675 -4.05845 +800 2 54.6285 35.827 37.4074 -17.7645 -17.3983 39.0191 +801 2 0.013954 36.4546 36.058 15.6745 -1.04323 18.583 +802 2 0.049019 37.9526 36.293 -63.1087 6.90888 -39.4544 +803 2 1.42802 35.9308 35.6826 4.08802 -6.56861 34.108 +804 4 0.435555 35.9801 38.2063 -13.4425 16.5914 -13.2273 +805 4 53.6198 36.2963 37.798 28.292 -21.2068 -7.80607 +806 4 54.2061 36.2134 35.3084 7.36084 -1.04605 -3.46995 +807 4 54.0713 38.2397 36.8522 27.1057 4.55429 -9.55418 +808 4 54.939 38.4282 35.2643 6.0019 1.58695 18.2366 +809 4 0.927863 38.3313 36.762 28.685 14.2218 21.5028 +810 4 1.30489 34.8989 35.3991 1.43296 -22.664 -21.4406 +811 4 2.25694 35.8344 36.4845 -24.5016 17.8738 -12.6534 +812 4 1.83634 36.4362 34.8335 13.635 15.7788 -26.8996 +813 1 0.008587 32.3758 38.733 13.7846 27.3237 -75.0314 +814 2 54.826 31.3 39.6331 17.4428 -14.6066 45.4768 +815 2 0.455793 31.7866 40.9725 -5.37526 1.66294 14.9859 +816 3 1.60943 32.1773 41.0547 11.2247 3.92934 -7.13086 +817 4 0.661532 32.0877 37.9163 -19.8505 19.9989 33.4434 +818 4 53.7452 31.1425 39.875 0.374502 -5.35979 -15.722 +819 2 0.574437 30.0043 39.0439 11.2157 23.6116 11.9724 +820 2 0.334302 28.7136 39.8578 -22.6665 -11.1233 -21.4622 +821 2 0.695999 28.7 41.3625 12.0844 -36.9796 9.0265 +822 3 54.7253 28.727 0.298109 10.889 15.3071 -4.11946 +823 3 1.91063 28.4506 41.7261 -30.7481 15.8042 -10.4483 +824 4 1.71086 30.1341 39.082 -19.7243 9.32222 0.312381 +825 4 0.358791 29.9926 37.9166 -2.62684 -19.8589 21.79 +826 4 0.882365 27.912 39.2891 -0.232785 0.308618 14.1734 +827 4 54.2301 28.3798 39.7718 17.2545 10.1943 -0.206185 +828 1 54.6325 31.7916 0.156881 38.5875 2.07504 -29.8841 +829 2 54.8631 32.3302 1.45975 7.41407 33.4343 26.7616 +830 2 1.21087 32.0241 2.20189 -33.1211 2.89979 -4.9396 +831 3 1.57835 32.811 3.08735 12.0797 -3.2377 -11.0832 +832 4 53.6756 31.6317 41.8616 -38.5912 -7.03962 0.740029 +833 4 54.9627 33.4927 1.3754 -11.7864 -35.033 -4.32612 +834 2 53.6666 32.0355 2.42828 -17.6969 8.95863 -1.18459 +835 2 52.1933 32.3158 2.0402 15.1012 41.0915 -15.9482 +836 3 51.3911 33.0513 2.74715 36.5037 -34.5123 -13.5772 +837 3 51.9207 32.0348 0.835441 -22.1157 -3.97518 6.29873 +838 4 53.9089 32.5595 3.33158 -2.01457 20.6007 30.7692 +839 4 53.6609 31.0051 2.75768 6.68313 -26.6133 3.27231 +840 1 1.77413 30.8239 1.99288 23.346 -11.0551 12.4557 +841 2 2.99412 30.3649 2.70859 20.7873 20.7026 2.58588 +842 2 4.37767 30.5585 1.9432 -4.58172 12.4342 76.2013 +843 3 5.43315 30.6356 2.6242 -17.4542 -1.84538 -14.1099 +844 4 1.23141 30.1158 1.49013 8.16278 -4.42375 -5.05013 +845 4 3.08709 30.9756 3.71749 -2.54673 -19.312 -31.0286 +846 4 2.99418 29.2776 2.99437 -11.6108 14.2547 -3.21828 +847 1 4.33484 30.73 0.643592 -44.4777 10.1896 -41.2897 +848 2 5.29878 31.2923 41.6537 25.3276 0.744315 3.96016 +849 2 5.54544 32.7486 0.121481 37.2819 -30.872 -27.7426 +850 3 4.68176 33.387 0.67546 -18.5336 28.2868 17.8008 +851 4 3.3891 30.7154 0.224796 5.58966 -1.49205 -0.51948 +852 4 6.30256 30.8588 41.8823 -3.47112 -15.4387 -8.82901 +853 2 4.8423 31.1802 40.1578 47.5835 -21.6785 -9.15502 +854 2 4.71332 29.7742 39.4637 -7.18766 34.2596 -8.85866 +855 2 5.63064 28.6968 40.0034 1.34917 -52.5839 -25.1875 +856 1 5.28494 28.1736 41.3081 -3.70672 3.58414 23.7744 +857 2 6.07557 28.0057 0.492928 -10.4577 4.69864 -29.3733 +858 1 7.37832 28.2278 0.392183 22.9004 -4.79637 26.256 +859 1 5.53705 27.6868 1.66636 -6.4094 -24.443 39.9026 +860 4 5.53303 31.787 39.5095 -0.196101 -2.7377 7.98036 +861 4 3.92152 31.7024 40.0755 -40.4143 20.5365 -6.7059 +862 4 4.89215 29.8961 38.3273 -2.53464 -0.592337 23.8175 +863 4 3.64677 29.4833 39.5295 -2.27017 -8.63927 2.61329 +864 4 6.69627 28.939 39.9328 9.42975 10.3347 -2.35439 +865 4 5.48992 27.7969 39.2806 7.04825 21.6687 20.0754 +866 4 4.27254 28.0467 41.4152 -4.83075 -3.28587 3.65899 +867 4 7.98538 28.2099 41.4852 -8.02405 3.18538 -21.0185 +868 4 7.94047 28.2423 1.24565 0.364194 -0.98827 11.7246 +869 4 4.53186 27.4078 1.78766 14.7644 10.3007 -8.4097 +870 4 6.1013 27.52 2.55737 -8.44391 7.70178 -27.0297 +871 1 6.79596 33.2006 41.6804 -27.9344 8.59735 4.57792 +872 2 7.15148 34.5952 41.8655 -38.9276 -12.1291 -1.68573 +873 2 6.77215 35.2911 40.5652 14.0197 56.9428 51.8707 +874 3 6.49158 34.715 39.5569 -13.5951 -21.5425 -43.0675 +875 4 7.31858 32.7386 40.9072 -2.655 4.76346 14.1821 +876 4 6.52583 35.0505 0.829338 19.3934 -10.3795 -24.0216 +877 2 8.63545 34.7883 0.159249 -4.7809 22.3707 74.7553 +878 3 9.31911 34.1951 41.0459 32.4158 -10.9375 -20.7672 +879 2 9.12239 34.1481 1.54228 -45.3508 12.3646 -39.5443 +880 4 8.86138 35.9031 0.177513 1.59938 -13.4643 1.18346 +881 4 10.1943 34.4871 41.2598 15.0836 -7.29109 -20.5697 +882 4 10.1218 34.4779 1.7295 32.9793 8.82002 13.7556 +883 4 9.1354 33.0404 1.45915 -3.89828 -1.77159 7.54964 +884 4 8.44695 34.5279 2.36236 9.39315 -9.78399 0.0431608 +885 1 6.96309 36.6454 40.6555 -22.2962 -38.3404 -33.8498 +886 2 6.94214 37.5275 39.5132 -15.3576 22.9899 27.1878 +887 2 8.03225 37.1821 38.5547 25.8315 2.87875 -39.3086 +888 3 7.87409 37.2091 37.3037 -11.7489 -2.94068 30.2829 +889 4 7.09017 37.0079 41.5812 4.58243 22.402 24.7274 +890 4 6.01646 37.4072 38.9238 -6.0018 -8.28766 -1.15408 +891 2 7.01182 39.0163 40.0252 -15.3603 -23.3284 55.3652 +892 2 5.61926 39.5384 40.7634 13.0639 11.727 -14.3013 +893 2 5.74741 41.0778 41.0735 34.612 -8.65688 -61.1535 +894 2 4.30485 39.278 39.9775 33.2171 6.29002 -24.4772 +895 4 7.23253 39.6079 39.1676 9.01238 29.648 -28.6912 +896 4 7.91826 39.1206 40.7867 -28.368 0.120823 -25.2036 +897 4 5.4532 38.9933 41.7239 13.5286 -1.18368 4.70417 +898 4 4.88701 41.4539 41.5866 -22.2749 9.39049 21.0562 +899 4 5.89633 41.7578 40.1185 -8.19165 -26.548 25.276 +900 4 6.67066 41.2365 41.6556 -0.494064 4.57358 11.7906 +901 4 4.18164 39.8273 38.9933 8.48456 -7.17755 11.4037 +902 4 3.44244 39.5261 40.5797 -17.807 1.17877 7.97341 +903 4 4.2824 38.1939 39.7929 -10.4691 -3.8299 -8.01616 +904 1 9.23783 36.8543 39.0653 -4.40645 21.0053 19.4908 +905 2 10.3275 36.5838 38.1582 31.0816 -25.3995 62.8998 +906 2 10.2997 35.2224 37.4613 6.04581 38.1949 -0.210763 +907 3 11.0208 35.1071 36.4655 -6.3656 -14.3958 -11.0193 +908 4 9.51333 37.1441 40.0706 -14.9717 -14.5173 -38.8343 +909 4 10.386 37.3498 37.3821 -1.67567 12.3369 -13.0834 +910 2 11.6168 36.6846 39.0604 -5.3878 -32.5356 -23.0633 +911 3 11.6818 35.7254 40.0985 -18.2206 13.507 16.8431 +912 4 11.7318 37.6647 39.5052 6.99822 20.9023 2.76215 +913 4 12.4798 36.426 38.4299 12.1644 16.7594 -11.1747 +914 4 12.2479 35.0511 39.7675 10.0745 -20.8981 -3.76732 +915 1 9.3909 34.3264 37.8733 -42.427 -15.3638 26.6935 +916 2 8.99216 33.1557 37.0842 54.1918 17.4661 1.85655 +917 2 8.44195 33.5842 35.7305 -20.833 60.571 55.2199 +918 3 8.45395 32.8337 34.8033 7.91235 -41.3122 -40.5547 +919 4 8.901 34.4208 38.8182 18.72 -3.57692 -25.7233 +920 4 10.0039 32.69 36.8915 -15.1884 -12.4868 -9.34361 +921 2 8.05349 32.1507 37.7268 -1.844 -26.1592 7.76215 +922 2 8.63612 31.2276 38.7905 8.98886 15.2457 3.52798 +923 3 8.28567 31.4376 39.9878 9.18033 -14.5703 -9.08999 +924 3 9.46172 30.3301 38.4185 -14.4281 10.7169 -2.66077 +925 4 7.57008 31.4717 36.9797 -4.32683 11.3708 2.99534 +926 4 7.24557 32.7088 38.1955 -18.7592 7.98312 4.87833 +927 1 7.76821 34.7903 35.7104 -0.921577 -49.5867 -7.77983 +928 2 7.00589 35.2713 34.5947 28.4194 33.7396 -49.4054 +929 2 7.85162 36.3274 33.7967 14.0615 10.3677 50.876 +930 3 7.59561 36.677 32.642 -11.5138 -12.0529 -0.0837023 +931 4 7.64044 35.3156 36.5601 -2.79577 12.0246 16.4277 +932 4 6.95142 34.464 33.8059 -8.74679 1.13416 10.6726 +933 2 5.60472 35.8897 34.9384 -10.82 -34.5279 -29.2679 +934 2 4.80808 34.6511 35.4252 21.4048 19.1212 -24.4535 +935 2 4.58939 34.449 36.7896 -8.79739 7.49237 6.99756 +936 2 4.44707 33.6361 34.4808 -22.1156 13.6667 13.0483 +937 2 3.78406 33.375 37.155 10.056 16.8174 60.0349 +938 2 3.57928 32.5992 34.8543 35.6828 20.067 14.4288 +939 2 3.32606 32.5122 36.2195 -36.4887 -32.5961 -12.2866 +940 3 2.43989 31.6229 36.7148 -5.7594 -17.052 -20.0699 +941 4 5.14192 36.3424 33.9886 5.39246 -18.3577 14.2305 +942 4 5.60606 36.7583 35.5989 7.01287 1.52307 19.367 +943 4 4.94491 35.1783 37.5598 -4.47364 -7.92921 -7.91861 +944 4 4.66046 33.7427 33.4202 4.87397 4.4658 -8.40916 +945 4 3.45738 33.1597 38.2449 15.2806 17.1295 -26.8514 +946 4 3.26795 31.828 34.148 -6.61111 -3.61155 -4.72788 +947 4 2.1868 31.1622 35.9134 -6.91994 -9.03483 11.406 +948 1 8.90205 36.8981 34.5027 -17.2687 17.5401 -60.9896 +949 2 9.70361 38.0134 33.9387 24.2231 -52.0812 37.3823 +950 2 8.8546 39.1711 33.5701 14.7092 18.0593 -4.53516 +951 3 9.06515 39.7643 32.526 6.45085 3.58457 -7.26619 +952 4 9.11675 36.6435 35.4518 3.62665 -3.0608 21.1339 +953 4 10.3861 38.3235 34.818 -10.2978 3.44266 -21.7419 +954 2 10.5787 37.5562 32.7307 -21.6135 -30.8037 4.74181 +955 2 11.6892 38.5091 32.4223 15.379 -13.1594 38.9153 +956 3 11.683 39.1804 31.4042 4.19267 20.0472 -18.4805 +957 1 12.6852 38.53 33.3751 41.3863 26.0224 -13.8263 +958 4 9.85905 37.4261 31.8504 20.0453 2.40541 7.8736 +959 4 11.053 36.5467 32.9319 -7.17885 8.97611 -4.2567 +960 4 12.817 37.8369 34.166 -15.4043 12.1891 -16.4176 +961 4 13.5001 39.2408 33.2564 -39.0039 -25.8302 4.81098 +962 1 7.96197 39.5631 34.4599 -33.9246 23.5433 37.1278 +963 2 7.21007 40.8276 34.5568 -18.3646 -15.2096 -14.7898 +964 2 8.22007 41.896 34.9201 0.758716 14.3361 -6.26955 +965 3 8.97663 41.7874 35.871 13.0919 -8.40756 13.8683 +966 4 7.83943 39.0508 35.3409 8.95409 -9.59767 0.690263 +967 4 6.70734 41.0591 33.5261 17.9743 -2.28149 22.8597 +968 2 6.0301 40.6247 35.6674 21.3841 11.5647 -11.8815 +969 2 4.89974 39.9794 34.8247 17.8968 2.41192 -27.2216 +970 2 5.64567 41.9074 36.4174 -5.31946 16.9228 -22.0167 +971 2 3.85064 39.271 35.6143 -7.9417 -14.8054 48.1955 +972 4 6.41951 40.0018 36.4929 2.02391 -20.04 -2.41117 +973 4 5.36435 39.2019 34.126 -8.73918 7.93575 11.5905 +974 4 4.48342 40.7424 34.1094 -6.00744 -5.42447 8.5897 +975 4 5.00487 41.8434 37.3074 -11.5574 -14.3762 1.01334 +976 4 5.12929 0.689353 35.6946 7.17582 1.37977 8.89479 +977 4 6.56067 0.460605 36.8355 2.18467 8.54142 -3.2903 +978 4 3.23423 39.9796 36.2601 8.91814 -10.815 -11.4927 +979 4 4.38489 38.5352 36.333 -17.3309 14.265 -14.1697 +980 4 3.16246 38.6765 34.9814 -1.3822 0.0882741 -1.23744 +981 1 8.27901 1.09677 34.1745 -17.8694 -35.8502 15.8719 +982 2 9.1495 2.17731 34.4611 25.5007 24.1899 -15.5427 +983 2 8.44305 3.45517 34.8181 7.33507 13.3767 -14.0082 +984 3 7.22584 3.58853 34.5952 14.73 6.44535 13.4701 +985 4 7.64387 1.07834 33.3925 -5.10967 17.8437 -25.4682 +986 4 9.72616 1.98981 35.3795 6.67437 -11.367 8.50474 +987 2 10.1416 2.3939 33.2727 7.80857 1.28792 -5.65283 +988 2 11.1754 1.27875 33.0535 -29.5709 -1.62172 8.74553 +989 2 12.298 1.25902 34.0434 45.8123 -20.4226 -15.8942 +990 3 13.4264 1.60062 33.6211 -9.09849 2.20405 14.6225 +991 1 12.1286 0.499484 35.1615 13.5856 38.0862 1.93866 +992 4 10.7117 3.33658 33.4062 0.0269402 1.80508 0.780117 +993 4 9.62868 2.54332 32.3022 -11.3844 1.67988 3.84081 +994 4 11.6026 1.39089 32.0291 1.1132 -6.32648 1.88738 +995 4 10.6463 0.304077 33.1517 4.80745 -4.48978 -13.057 +996 4 11.1623 0.324257 35.4356 -7.1112 -9.24345 12.7946 +997 4 12.86 0.645961 35.8984 -11.3978 -13.87 -11.7385 +998 1 9.29061 4.442 35.2624 -22.3208 40.9019 24.8252 +999 2 8.81116 5.82611 35.6978 -18.3987 -9.60009 -41.1421 +1000 2 7.90959 6.36535 34.5148 35.1086 -14.4229 -13.6713 +1001 3 8.27789 6.14754 33.3333 -13.6173 9.04219 21.6414 +1002 4 10.326 4.35425 35.3433 -15.5473 -10.8229 -5.10085 +1003 4 8.07437 5.70026 36.5174 9.02025 -1.47766 10.124 +1004 2 9.99583 6.76313 36.1565 -25.1565 20.6308 -28.9867 +1005 2 11.135 6.93617 35.1361 2.62363 -10.5046 6.46017 +1006 2 12.4502 7.42969 35.8581 -25.4448 -27.2564 -27.4451 +1007 2 12.3858 8.85842 36.3442 -55.084 26.5775 24.6628 +1008 1 13.634 9.41318 36.7712 33.8844 -44.8334 11.878 +1009 4 10.2929 6.30703 37.0832 24.0012 -1.96783 25.2264 +1010 4 9.73373 7.84957 36.4159 -14.1304 -26.7275 0.147522 +1011 4 10.8081 7.68154 34.3572 5.16283 -4.02502 4.78839 +1012 4 11.298 5.9636 34.5725 5.23915 16.0099 8.41141 +1013 4 13.159 7.4137 35.035 25.5516 -2.14082 -10.0364 +1014 4 12.8083 6.68649 36.6117 -1.06896 6.08822 -0.205097 +1015 4 11.642 8.94716 37.2538 22.1051 -1.45756 -27.4817 +1016 4 11.9592 9.50431 35.5025 9.97141 -3.64215 15.7788 +1017 4 13.6538 10.3723 37.0555 -8.09423 13.3796 3.79584 +1018 4 14.2885 9.3339 36.0056 2.60625 13.8446 -5.44478 +1019 4 14.0928 8.83644 37.5176 -15.06 24.3666 -13.6607 +1020 1 6.73429 6.959 34.8261 9.36917 -0.537504 -3.37326 +1021 2 5.68914 7.48312 33.9811 -11.6093 0.198368 -29.7566 +1022 2 4.72257 6.43001 33.3633 23.9678 57.8121 29.6097 +1023 3 3.69345 6.80336 32.8731 -41.5354 18.269 -25.9458 +1024 4 6.5403 7.08067 35.8075 -8.4584 6.57489 23.7637 +1025 4 4.95828 8.08289 34.6274 18.5559 -1.63885 -10.0577 +1026 2 6.30301 8.33887 32.7628 1.61604 -0.894199 46.3222 +1027 2 6.96232 9.68302 33.2113 17.5203 -12.0258 -13.4607 +1028 2 6.11334 10.8061 33.8152 -7.60378 12.6352 19.0416 +1029 3 5.31496 11.4419 33.0422 10.0378 -5.26853 5.86857 +1030 3 6.28181 11.1536 35.05 3.36103 -18.7342 -31.8229 +1031 4 5.5011 8.60814 32.0808 -13.4162 -1.3456 -15.0867 +1032 4 7.01778 7.64283 32.2215 -8.51236 18.4517 -1.11608 +1033 4 7.483 10.1113 32.3225 -5.01151 2.49106 -4.14977 +1034 4 7.84021 9.44334 33.8428 -3.17944 -2.15711 8.7111 +1035 1 4.98957 5.17145 33.408 31.7294 -73.5208 5.3031 +1036 2 4.03057 4.12888 32.9492 20.6717 -14.7005 -20.2168 +1037 2 2.6598 4.36206 33.592 -3.0444 -3.65398 -36.823 +1038 3 2.63368 4.6245 34.7729 -17.9957 9.5377 28.5993 +1039 4 5.93287 4.88555 33.7778 -25.4301 -4.21673 -10.3446 +1040 4 3.97065 4.08898 31.7849 -0.621936 10.7688 28.6704 +1041 2 4.54797 2.73693 33.4323 -9.78314 13.2989 35.3654 +1042 3 5.7396 2.38581 32.8061 3.87836 -1.00687 -28.9834 +1043 4 3.83029 1.94659 33.1597 -9.96533 -6.0451 7.8725 +1044 4 4.7579 2.77573 34.5879 -14.8326 -6.64015 -28.538 +1045 4 6.39905 2.57303 33.4496 16.1931 5.10903 8.49462 +1046 1 1.55493 4.20465 32.7937 9.73391 7.12296 -2.26043 +1047 2 0.143907 4.28394 33.2313 13.768 -18.1657 13.0528 +1048 2 54.6863 2.83094 33.3214 -0.0746788 -18.1404 42.9803 +1049 3 54.7972 2.04898 32.3833 -5.36381 -6.57018 -20.4337 +1050 4 1.75536 3.84626 31.8337 -17.5999 5.97734 12.9737 +1051 4 0.145346 4.72929 34.2869 -5.52407 -1.41906 -16.7638 +1052 2 54.0936 4.99047 32.3072 48.5491 53.4262 27.9832 +1053 3 54.4431 6.39026 32.3568 26.5828 -36.1107 8.98461 +1054 2 52.7233 5.01429 32.8691 -55.1486 3.23885 2.70228 +1055 4 54.1505 4.66496 31.2868 0.0550865 -16.0071 -29.7017 +1056 4 53.7986 6.85268 31.88 -20.6445 25.8891 -20.893 +1057 4 52.6197 5.54793 33.8322 5.93951 -5.3567 9.34144 +1058 4 52.3467 3.98503 32.9647 -9.06602 -5.34833 4.63236 +1059 4 51.9747 5.55452 32.2255 9.49609 -7.51028 -3.22615 +1060 1 54.1802 2.39741 34.5222 -14.8232 32.9081 27.5353 +1061 2 53.4465 1.14651 34.785 33.9277 15.1 -62.0226 +1062 2 52 1.44639 34.4384 -40.9452 -8.29472 -14.3346 +1063 3 51.516 2.52365 34.8247 -1.26544 -9.47139 -8.9244 +1064 4 54.0715 3.07846 35.3501 9.6448 -17.4772 -31.2652 +1065 4 53.9076 0.391021 34.1043 -10.2836 -7.20705 -0.475865 +1066 2 53.6069 0.737389 36.2058 40.6624 3.41232 47.0409 +1067 2 0.15698 0.778637 36.8849 -22.9225 14.5477 7.59965 +1068 2 0.184063 0.045177 38.2545 -1.48959 -18.0819 6.68284 +1069 2 1.19764 0.213126 35.924 -17.0247 17.4527 -16.4279 +1070 4 53.1759 41.6554 36.3315 -4.28574 -19.6707 2.88188 +1071 4 52.9166 1.40322 36.7387 0.80484 4.57892 22.2756 +1072 4 0.570353 1.84035 37.1024 -27.1105 -11.6335 -5.02718 +1073 4 54.3756 0.329349 38.9832 1.77724 8.98271 -8.45905 +1074 4 1.16626 0.241414 38.7954 -11.8595 -7.79047 -8.4361 +1075 4 0.0237 40.841 38.1265 8.8292 11.305 -0.869273 +1076 4 2.1582 0.044818 36.439 11.171 3.86438 -4.7836 +1077 4 1.22244 1.0066 35.1406 25.1303 -1.4606 -0.0516333 +1078 4 0.965216 41.2564 35.3038 -8.75588 -20.9773 6.66787 +1079 1 51.2089 0.49816 33.7614 57.6433 8.13256 28.0245 +1080 2 49.794 0.627079 33.5149 3.58551 37.6409 23.5907 +1081 2 49.1504 41.7362 34.5845 -39.3958 -31.0429 53.6988 +1082 3 49.3072 40.5133 34.7023 12.9245 12.8492 -11.6005 +1083 4 51.5663 41.4343 33.8516 -6.054 3.49016 -14.1934 +1084 4 49.5236 1.72635 33.6347 -1.89472 -11.9516 -1.26615 +1085 2 49.2899 0.093076 32.2111 -20.0469 10.239 -57.1496 +1086 2 49.5504 1.0758 31.0546 44.1484 5.96661 -35.419 +1087 1 48.7105 2.02971 30.4517 -2.34523 -25.3315 39.2373 +1088 2 50.7977 1.22066 30.3277 -75.7848 7.88288 4.96893 +1089 2 49.299 2.59293 29.3763 -23.865 8.39496 11.0232 +1090 1 50.5677 2.14293 29.3127 -12.36 -15.4034 27.3398 +1091 4 48.1533 41.8436 32.187 18.4481 1.21563 9.00361 +1092 4 49.725 40.9798 32.0543 -2.35302 7.24771 -7.56512 +1093 4 47.7373 2.26457 30.8018 19.6426 -7.09987 -8.69392 +1094 4 51.6402 0.582035 30.3922 15.3203 -1.97636 0.19948 +1095 4 48.6832 3.25559 28.7541 24.649 -5.28154 -1.94766 +1096 4 51.2124 2.39582 28.5799 18.4236 6.97779 -14.3308 +1097 1 48.3633 0.438016 35.503 -1.69139 30.1001 11.6909 +1098 2 47.6687 41.7006 36.6492 0.613805 18.6924 -40.9612 +1099 2 46.264 41.3694 36.1307 -7.02361 -30.4834 5.87484 +1100 3 45.3463 0.246853 35.8895 18.8914 5.06283 8.3795 +1101 4 48.1281 1.45816 35.4039 5.5506 -16.4063 -0.101422 +1102 4 48.2062 40.7837 36.9784 6.36967 -2.21031 -8.42979 +1103 2 47.5958 0.687745 37.8565 -25.4558 59.2473 29.5222 +1104 2 46.6931 0.064749 39.0402 -2.78345 4.00632 18.8053 +1105 2 47.0383 40.4557 39.4221 -33.2538 18.6268 -20.4936 +1106 2 46.93 0.927044 40.3419 31.4794 -11.2994 1.29194 +1107 4 47.1354 1.76149 37.5629 9.48386 -42.5729 7.15928 +1108 4 48.6298 0.997945 38.2155 -14.6806 -19.3715 -2.98409 +1109 4 45.5391 0.148422 38.8474 30.3772 -4.98305 -7.99897 +1110 4 47.9695 40.2725 39.9165 32.6255 3.33763 11.188 +1111 4 46.9967 39.7545 38.5575 0.158611 5.44488 0.559019 +1112 4 46.2719 40.0836 40.1333 -2.82757 0.291607 -0.331179 +1113 4 48.0832 1.04093 40.5802 -35.3824 -1.71169 -8.39188 +1114 4 46.4823 0.388091 41.2333 0.118939 13.4124 -7.57083 +1115 4 46.4764 1.95182 40.2253 3.79994 -8.06745 5.67231 +1116 1 46.1155 40.0363 35.9994 32.2071 3.49142 -20.6914 +1117 2 44.9353 39.2817 35.7114 0.014229 -40.6503 61.2515 +1118 2 44.4179 38.8949 37.157 4.06758 -27.6469 18.473 +1119 3 45.1574 38.4668 38.0935 -15.0116 19.769 -34.2637 +1120 4 46.9934 39.487 36.0733 -14.8983 -9.5139 0.794979 +1121 4 44.1193 39.9156 35.4266 -15.9448 22.0113 -37.9939 +1122 2 45.2307 37.9502 34.8403 3.73878 29.7444 42.1248 +1123 2 44.043 37.0324 34.841 -52.9272 -13.7306 14.9234 +1124 2 45.6185 38.368 33.4399 7.42128 1.51593 -38.9882 +1125 4 46.0406 37.394 35.3664 8.69137 1.61483 -3.86581 +1126 4 43.4486 36.945 35.811 20.0159 3.18287 -12.2628 +1127 4 44.3645 35.9957 34.6605 0.118723 -8.68919 -11.9568 +1128 4 43.2413 37.3473 34.1301 7.80666 -3.9283 -7.25571 +1129 4 46.619 38.86 33.4411 -0.357581 -2.40345 0.816384 +1130 4 44.931 39.1517 33.0584 -3.3954 -0.0150932 -1.42103 +1131 4 45.65 37.5606 32.6192 -0.759822 9.78394 24.304 +1132 1 43.0637 38.9039 37.3301 16.2039 -1.11298 52.5829 +1133 2 42.3901 38.4825 38.6382 8.13363 32.9232 -36.228 +1134 2 41.8706 37.0909 38.467 10.8397 -12.8704 71.8875 +1135 3 41.4837 36.7016 37.4073 -23.2793 -18.8499 -56.9312 +1136 4 42.5052 38.9697 36.5072 -31.8536 4.61581 -21.2592 +1137 4 43.1805 38.4127 39.3754 18.2924 -0.774441 22.1039 +1138 2 41.3003 39.5089 39.1545 11.9555 -3.56475 0.849013 +1139 2 41.9844 40.8891 39.6202 11.8289 -38.672 35.4909 +1140 2 41.1032 0.170603 39.4187 0.299182 35.0028 -21.1028 +1141 2 42.4599 40.8175 41.1074 30.4283 -6.43954 -3.58257 +1142 4 40.7378 39.0113 40.0259 3.55617 13.764 -16.8053 +1143 4 40.5882 39.6834 38.2893 4.7664 -2.44084 15.6093 +1144 4 42.9174 41.0251 39.0897 16.4872 7.11459 -27.4623 +1145 4 41.5448 1.21778 39.6878 -5.64292 -30.3916 -9.38981 +1146 4 40.1969 0.063548 40.0003 -21.2204 -0.202137 11.1399 +1147 4 40.8028 0.152067 38.3319 -0.566182 12.1591 9.51378 +1148 4 41.6814 40.5448 41.8308 -8.42244 -8.91154 4.32363 +1149 4 42.887 41.7652 41.4977 -6.37808 7.37928 -6.87517 +1150 4 43.378 40.1338 41.1957 -24.337 0.845851 0.000130478 +1151 1 41.833 36.287 39.5864 -11.7269 -9.12911 -32.1296 +1152 2 41.2021 34.942 39.6247 -13.3362 -7.3841 -33.9439 +1153 2 39.8438 35.1095 40.3167 -2.23182 -18.8086 0.488263 +1154 3 39.8319 35.4679 41.5133 -14.6884 5.15074 -23.9167 +1155 4 42.1857 36.6275 40.4819 6.41783 1.01312 8.70708 +1156 4 41.0734 34.4248 38.4971 0.391294 34.8961 43.783 +1157 2 42.0436 33.9307 40.4129 10.4134 -33.9193 29.8386 +1158 2 41.3224 32.6645 41.0046 18.9395 -8.84266 -15.0635 +1159 2 42.1741 31.41 41.1086 26.4224 -37.0889 -5.20117 +1160 1 43.3231 31.527 0.12404 8.16009 54.2467 4.49909 +1161 2 44.392 30.7336 0.312631 -11.8213 -13.5239 -25.8004 +1162 1 44.683 29.6211 41.5456 -0.875823 -13.5136 -9.93246 +1163 1 45.3567 31.1357 1.10637 -40.5913 52.4111 16.4216 +1164 4 42.6035 34.3028 41.3288 -3.49471 12.9719 -23.3931 +1165 4 42.7742 33.539 39.6653 10.0701 4.50298 5.32726 +1166 4 40.5106 32.3417 40.3808 -25.7726 1.2565 -24.6898 +1167 4 40.8602 32.7415 0.05618 -15.4481 23.3498 31.3369 +1168 4 42.5775 31.2408 40.0556 -4.97325 -9.97334 14.9806 +1169 4 41.5239 30.4863 41.4302 18.1675 25.5375 -11.7586 +1170 4 43.4773 32.5278 0.495625 -12.2609 -36.3484 -6.98406 +1171 4 44.1847 29.2591 40.6938 -0.904676 10.2844 18.7349 +1172 4 45.5197 29.0942 41.8602 -5.70345 -5.08504 -8.10101 +1173 4 45.1981 31.9946 1.67722 9.89922 -9.52065 -4.53153 +1174 4 46.1063 30.5613 1.39407 36.7186 -26.409 10.0907 +1175 1 38.7328 34.6894 39.6013 4.46457 11.7984 -0.102478 +1176 2 37.3765 34.7683 40.1611 -21.3466 -3.56213 -4.53749 +1177 2 37.2086 33.6902 41.246 35.3807 -34.3386 -58.3615 +1178 3 37.7056 32.5617 40.9531 -12.3371 14.3328 36.9617 +1179 4 38.7903 34.2139 38.6548 1.70782 19.6852 25.699 +1180 4 37.2103 35.7436 40.6571 5.74575 10.1154 -0.0963519 +1181 2 36.2415 34.546 39.0669 -3.18027 -0.0437456 15.212 +1182 2 36.1408 35.6492 37.9204 39.4301 -27.8538 10.4422 +1183 2 35.3755 35.0392 36.7616 2.61616 7.91146 -44.6699 +1184 2 35.4893 36.9279 38.4153 -43.6456 26.6605 -35.0263 +1185 4 35.2587 34.5127 39.627 5.22859 0.340849 -7.95454 +1186 4 36.3572 33.4874 38.6664 0.260323 14.7009 0.217726 +1187 4 37.2087 35.8382 37.5664 -16.1128 3.65721 5.42823 +1188 4 35.4477 35.6456 35.7653 9.36321 -17.9472 26.5571 +1189 4 34.3056 35.0154 36.9225 -21.8403 -4.8414 12.2215 +1190 4 35.6878 33.9672 36.6241 -0.675121 9.51327 -11.2908 +1191 4 35.3533 37.7352 37.5449 14.646 -26.9923 30.0517 +1192 4 36.0883 37.365 39.2255 0.238586 8.99863 9.94523 +1193 4 34.398 36.7236 38.7331 27.4296 3.60145 2.66053 +1194 1 36.5178 33.9861 0.43319 -0.886806 18.5628 10.9627 +1195 2 36.4316 33.2481 1.68402 -23.714 -26.6299 -2.13495 +1196 2 35.1244 33.7124 2.42366 15.5385 -30.3313 2.36588 +1197 3 34.7644 34.9026 2.51705 2.20922 -14.5348 -10.7235 +1198 4 35.9714 34.8641 0.38304 3.21168 -9.87759 6.15105 +1199 4 36.3983 32.0948 1.44989 -1.82422 33.6343 5.26777 +1200 2 37.6595 33.5578 2.59019 11.8109 -15.526 -8.95992 +1201 2 37.7925 32.6548 3.8947 -1.46637 37.0951 -40.7395 +1202 2 39.0729 32.9162 4.76145 9.33062 17.9701 -6.69315 +1203 1 39.1272 34.3057 5.34055 -12.0513 -47.2871 -14.6565 +1204 2 40.0361 34.6964 6.22226 19.4309 2.99614 33.8109 +1205 1 41.0505 33.9844 6.76852 5.72064 -28.58 -41.8643 +1206 1 39.7581 35.8909 6.75898 -16.291 -41.0737 -43.8581 +1207 4 37.6558 34.6526 2.69615 5.74115 8.80853 20.4616 +1208 4 38.5677 33.342 1.97837 2.62182 1.38243 0.976295 +1209 4 37.7082 31.6119 3.52088 7.51898 -7.43262 10.1799 +1210 4 36.8684 32.8569 4.46033 -3.22235 -4.22142 15.6354 +1211 4 40.0987 32.7161 4.26669 -27.6432 -2.90908 0.926336 +1212 4 38.962 32.1623 5.56307 10.4764 0.325422 12.3641 +1213 4 38.2956 34.9173 5.26655 4.54825 -8.39051 -8.34855 +1214 4 41.5169 33.1039 6.38476 -28.6266 25.8655 1.14646 +1215 4 41.608 34.3491 7.51377 7.8916 19.9746 23.1278 +1216 4 38.9281 36.336 6.40181 -18.5651 19.0558 1.42199 +1217 4 40.2702 36.4189 7.40653 35.8571 19.9594 40.0309 +1218 1 34.4344 32.6714 2.9841 11.9274 27.4669 5.1488 +1219 2 33.2874 32.9292 3.81699 -8.08564 -7.68863 -5.88537 +1220 2 32.3224 31.7651 3.90854 -17.2979 -17.3182 38.1098 +1221 3 31.6331 31.611 4.98833 24.1293 6.49939 -41.9496 +1222 4 34.8176 31.7057 3.00707 -6.83555 3.8884 -0.368261 +1223 4 33.5991 33.291 4.83995 -4.39941 -8.915 -13.4113 +1224 4 32.6658 33.7351 3.38441 -0.220857 8.92322 -1.65762 +1225 1 32.2676 30.8833 2.86064 7.18924 -6.28537 -11.1453 +1226 2 31.5304 29.6622 2.84554 -44.3988 -8.55194 41.4736 +1227 2 32.0114 28.4719 1.98523 24.1065 42.5964 20.3644 +1228 3 31.2338 27.9142 1.1781 -2.45095 -15.5808 -11.9787 +1229 4 32.835 30.9065 1.99868 7.60542 11.1676 6.22148 +1230 4 31.4977 29.325 3.94534 -1.848 -5.68036 -21.1002 +1231 4 30.428 29.9278 2.63242 23.021 -11.1829 0.219584 +1232 3 33.2484 28.1785 2.03016 -12.1294 -5.65166 -6.61988 +1233 6 29.6841 33.0367 2.60309 -21.6771 -19.3453 -3.47113 +1234 4 28.7948 33.122 2.96731 -0.0142705 6.34055 1.55972 +1235 4 29.6278 32.12 2.27587 17.6678 13.2788 -5.74715 +1236 6 1.91248 24.7582 28.0699 4.20875 0.224039 17.8866 +1237 4 1.01839 24.445 28.2798 3.51323 0.855994 -2.65004 +1238 4 2.43926 24.5752 28.8738 -5.90795 -3.90565 -13.7536 +1239 6 8.97597 35.4266 7.06834 5.04 -9.06312 -1.25332 +1240 4 8.25108 36.0541 6.94232 -0.597114 -1.88223 0.564045 +1241 4 9.78632 35.9205 6.90416 2.6498 8.25727 -2.9232 +1242 6 37.9306 35.2271 23.5275 -29.4197 8.6633 8.88923 +1243 4 37.6331 35.3765 22.6307 -13.538 -1.59668 -6.74716 +1244 4 38.842 35.1051 23.4294 41.2281 -9.97035 -1.96517 +1245 6 11.37 34.6061 20.3231 29.8185 18.8627 -18.7977 +1246 4 10.4583 34.7066 20.5358 -23.2141 -5.0309 12.4901 +1247 4 11.7775 33.9686 20.9051 -0.738527 -14.291 8.66526 +1248 6 3.04799 13.1152 13.5136 35.0099 19.4917 13.0876 +1249 4 2.1896 12.8159 13.7818 -12.1985 -3.35561 6.33527 +1250 4 3.35102 13.7724 14.1976 -9.84998 -14.2313 -17.3692 +1251 6 9.17749 22.3786 24.885 -4.81993 3.49977 17.5169 +1252 4 8.99718 21.9861 24.0258 2.67933 0.293026 -6.97176 +1253 4 8.3097 22.5185 25.3032 2.93356 -2.2731 -6.67367 +1254 6 31.1417 36.1188 7.44168 3.96214 -4.62609 4.57576 +1255 4 30.9859 35.1633 7.26174 3.91063 19.8072 -8.10584 +1256 4 31.8759 36.4086 6.86762 -9.43736 -11.0335 0.220205 +1257 6 20.3122 0.171955 30.1364 24.228 8.43021 7.74329 +1258 4 20.1467 1.09565 29.8896 -9.06662 -5.17995 0.122132 +1259 4 21.2388 0.205679 30.4532 -11.6638 -2.99571 -4.85501 +1260 6 32.6752 3.01477 5.14905 7.73556 0.409651 25.0992 +1261 4 32.0607 2.27652 4.98052 6.16059 10.1356 9.58904 +1262 4 32.7887 3.0902 6.13894 -10.3787 -11.0045 -24.4474 +1263 6 26.2394 8.28697 11.5977 20.1187 4.68976 23.8355 +1264 4 26.2546 7.39802 11.997 -1.81228 7.23555 -2.12718 +1265 4 26.8422 8.82061 12.1901 -18.4274 -19.7459 -23.7973 +1266 6 1.08156 20.2558 0.892389 0.445896 -40.4816 -11.3523 +1267 4 0.921065 19.2784 0.845371 -9.22979 28.4068 22.5673 +1268 4 1.8129 20.2775 0.290341 19.5395 18.0975 -11.5753 +1269 6 29.152 22.9159 1.42964 -10.353 11.3862 1.77115 +1270 4 28.6638 23.7219 1.70393 12.045 -15.0113 -5.27942 +1271 4 29.6471 22.6066 2.20087 0.367353 7.17244 2.17898 +1272 6 34.1439 34.8173 6.47837 -14.6134 34.7664 -13.6599 +1273 4 34.8234 34.3556 6.01831 17.3611 -13.8412 -2.82442 +1274 4 33.8746 34.3136 7.2252 -0.385324 -14.0922 18.4225 +1275 6 25.1602 37.1811 26.5285 37.3138 -10.4299 -24.6025 +1276 4 24.6611 37.8475 26.9305 -29.1138 25.753 30.5337 +1277 4 25.9902 37.6718 26.3423 -2.02618 -10.7722 -5.27175 +1278 6 14.5359 22.233 15.6757 -38.1082 -52.4317 -17.2355 +1279 4 14.0373 21.3219 15.6008 31.4468 51.1923 15.0921 +1280 4 14.2115 22.7284 14.9124 6.42666 2.88962 4.6194 +1281 6 2.85765 5.85542 4.07926 -11.0889 31.9932 11.5474 +1282 4 3.43051 5.71014 4.8302 4.50985 -17.8875 11.7313 +1283 4 2.47546 6.74142 4.27679 -1.8522 -19.462 -7.62003 +1284 6 27.6173 26.7153 22.7048 3.02536 -24.7668 37.2 +1285 4 26.7794 26.2561 22.7471 -5.49099 -10.4557 3.23975 +1286 4 27.5338 27.2427 21.9498 -2.81898 29.5538 -40.3285 +1287 6 17.7815 0.60275 22.3967 -9.44347 22.192 16.8557 +1288 4 17.1106 0.664367 23.1174 8.05472 -4.70436 -13.4643 +1289 4 18.0991 1.53066 22.3547 -2.50437 -12.3009 -7.04453 +1290 6 8.08803 9.43976 10.5674 4.80966 -47.9744 28.0614 +1291 4 8.01535 10.2871 10.1695 -8.25869 32.7817 1.56345 +1292 4 8.12483 9.46261 11.5696 0.628604 12.1613 -30.4224 +1293 6 15.3459 8.71493 30.7579 -11.6347 7.91644 6.32427 +1294 4 15.6589 9.0755 29.9373 15.0271 -3.29406 -15.5675 +1295 4 14.5238 9.21191 30.8811 4.80809 -7.40019 11.405 +1296 6 11.0133 17.2839 37.5617 38.0352 -12.2544 -11.7999 +1297 4 10.7898 18.2056 37.405 -17.5453 -0.0751596 7.29682 +1298 4 10.2607 16.7791 37.8546 -17.0302 3.42722 4.74802 +1299 6 42.1004 25.1498 20.3879 -5.861 18.5914 -24.6259 +1300 4 41.6093 25.7579 19.7998 14.6917 -4.46771 2.10695 +1301 4 41.6207 25.2703 21.1911 -4.19275 -5.86855 25.2901 +1302 6 25.8665 4.70671 33.8486 1.7241 -2.25531 12.4518 +1303 4 25.7694 4.46132 32.9448 -0.891619 -14.6084 -22.569 +1304 4 25.7648 5.65611 33.7952 0.475958 14.7418 11.4125 +1305 6 28.7412 10.81 24.3536 52.8166 -39.1996 0.778281 +1306 4 29.1275 10.6396 25.241 -21.7381 14.0631 -10.6288 +1307 4 29.4032 10.2753 23.8346 -27.1554 16.6107 -4.2243 +1308 6 5.01189 41.8147 11.1021 -10.1881 -24.042 21.7575 +1309 4 5.95007 41.5814 10.9281 -9.39093 5.64723 11.7156 +1310 4 4.65803 41.218 11.8386 16.8172 15.7397 -32.6044 +1311 6 51.752 12.7769 30.1551 43.115 4.76279 10.9474 +1312 4 51.4305 13.1775 29.3474 0.253404 7.28674 -13.194 +1313 4 52.748 12.9494 30.1798 -32.3905 -5.4963 0.108494 +1314 6 7.60816 6.20909 6.53323 -10.2625 -22.9413 3.332 +1315 4 6.75131 6.36879 6.93991 1.04412 16.1391 1.16177 +1316 4 7.47061 5.28848 6.27373 8.51121 0.713964 -9.51027 +1317 6 14.6661 26.987 30.1548 0.873164 4.36141 0.355215 +1318 4 14.582 27.1099 31.1251 1.36022 -4.92112 -14.8153 +1319 4 15.2266 27.7026 29.8055 -8.21389 -0.931444 11.6021 +1320 6 15.3264 3.73283 21.1643 -10.33 -3.58504 -6.01241 +1321 4 14.8638 4.27764 21.8464 -0.83547 -19.2341 -16.6374 +1322 4 14.7237 3.15769 20.6119 12.9204 22.2517 21.9232 +1323 6 18.6273 30.44 6.46759 12.0392 -23.7352 17.6185 +1324 4 19.0475 29.6706 6.98693 -16.3462 35.3997 -15.3304 +1325 4 19.3457 31.0864 6.33287 -5.93154 -6.64461 4.30044 +1326 6 40.7697 1.30953 12.81 -7.42069 2.69181 -0.220133 +1327 4 39.8771 1.67487 12.9664 8.30469 -1.85755 -8.75546 +1328 4 41.0842 1.69163 11.9727 1.23155 -3.30642 0.910493 +1329 6 17.7383 20.7435 41.5913 -9.25323 7.68498 -13.188 +1330 4 16.7989 21.0745 41.5362 27.0903 -5.35562 -1.00027 +1331 4 18.2994 21.1605 40.9095 -9.45455 4.50919 10.4973 +1332 6 20.4558 2.13279 12.3403 -30.0447 18.1891 -47.0851 +1333 4 19.8108 1.39557 12.2573 15.3988 9.29294 19.6505 +1334 4 20.198 2.64755 11.5038 12.9177 -17.2886 33.121 +1335 6 9.85302 37.1833 18.074 6.71136 -14.9304 -23.7857 +1336 4 9.92221 37.5908 18.9423 10.0316 4.42551 4.50256 +1337 4 10.7455 37.1149 17.635 -18.8442 6.56171 18.5414 +1338 6 22.8282 7.40677 18.9114 -6.23678 0.804763 -35.7596 +1339 4 23.277 7.74075 18.0859 -11.7777 -2.90663 21.4919 +1340 4 21.8757 7.287 18.6972 16.9035 1.85128 0.334711 +1341 6 12.8573 6.85868 39.0594 6.78943 -21.4649 -19.4044 +1342 4 12.3495 7.63841 39.2092 -16.9303 20.8315 3.03628 +1343 4 13.4346 6.77393 39.8096 4.28484 1.06254 16.6435 +1344 6 10.1565 2.40612 23.2517 -6.6479 23.561 31.1588 +1345 4 10.4099 1.98923 22.4441 -4.01424 -6.38426 -29.0568 +1346 4 9.49005 3.10319 23.0571 9.63138 -11.2124 -3.87372 +1347 6 12.5542 20.2161 19.5705 -7.34833 3.07917 -34.9419 +1348 4 11.7057 19.8107 19.7825 -3.93433 -3.45282 3.31954 +1349 4 12.4683 20.3478 18.5882 13.2674 0.522362 30.6915 +1350 6 53.8557 6.35775 18.9347 50.5758 7.3162 -16.743 +1351 4 53.0168 6.07594 19.2456 -23.2698 -10.9568 16.0684 +1352 4 54.5479 6.04339 19.5529 -19.4302 5.44353 -5.27334 +1353 6 1.75058 4.00903 13.2441 23.5728 -28.6973 -20.2265 +1354 4 1.21884 4.54583 13.7916 -24.4496 15.7193 15.6535 +1355 4 1.39876 3.10072 13.3493 7.47096 11.1043 -1.96467 +1356 6 2.68902 16.4655 4.58797 17.5454 -16.7281 26.1549 +1357 4 3.46748 16.2798 5.17846 -23.6637 11.3752 -17.7986 +1358 4 3.0109 17.1109 3.97132 2.36318 9.59715 -15.9168 +1359 6 22.6274 7.40182 35.0529 -33.099 -8.93325 -69.8706 +1360 4 21.8922 7.07895 34.3703 46.348 20.1786 48.898 +1361 4 22.5995 6.76718 35.7474 -8.35572 -20.8537 22.0506 +1362 6 30.6396 27.885 19.9 19.0923 35.3411 -25.0547 +1363 4 31.1106 28.5954 19.3754 -18.5592 -24.8751 19.2783 +1364 4 29.9814 27.5098 19.295 5.17179 -8.35919 5.46264 +1365 6 18.3573 9.54392 6.2041 9.96047 7.12844 39.1223 +1366 4 18.327 9.09374 5.37857 3.10343 -12.6247 -24.8999 +1367 4 19.1177 9.18386 6.70986 -9.9052 0.872737 -11.1311 +1368 6 21.018 30.3894 30.8381 -12.2875 -2.46479 40.1773 +1369 4 21.7266 31.0151 30.932 9.98027 8.24448 -8.07198 +1370 4 20.7269 30.28 31.7939 -0.642204 -5.24287 -40.3987 +1371 6 28.323 4.36597 15.0837 1.12527 39.8195 10.6489 +1372 4 27.8986 3.55092 15.2676 -12.4099 -32.2848 2.02696 +1373 4 29.0009 4.19376 14.4446 14.1396 -7.65384 -8.86362 +1374 6 12.7814 0.64254 16.5262 -20.2521 41.8336 -1.49998 +1375 4 13.0387 1.47629 17.0069 -1.64601 -27.4009 -13.133 +1376 4 12.0897 0.933072 15.8712 20.715 -4.46996 16.4219 +1377 6 27.5603 35.1844 8.24072 -26.8161 -1.20469 12.7263 +1378 4 28.0791 35.3455 7.47089 6.94403 2.76433 -19.537 +1379 4 26.8275 34.582 7.96906 18.9853 12.4469 9.56437 +1380 6 24.0704 5.17451 40.9985 43.9791 -14.9803 45.716 +1381 4 24.6298 5.96615 41.2045 -19.6374 -8.83437 -20.0494 +1382 4 23.3625 5.28724 40.4007 -22.1054 20.8081 -27.5224 +1383 6 16.8467 24.9145 28.3061 -32.8066 71.0274 -23.4158 +1384 4 15.8676 25.1613 28.454 39.6061 -31.4713 1.92714 +1385 4 17.0718 25.6559 27.6632 3.37355 -28.1253 20.4487 +1386 6 20.8411 12.7971 17.0095 43.3655 -24.1139 -5.17775 +1387 4 20.9692 13.6698 17.4217 0.0861137 -1.96629 -7.53612 +1388 4 21.7712 12.4167 16.7645 -47.1299 18.5523 16.3808 +1389 6 35.7683 23.0344 30.9263 1.08866 -13.108 5.55839 +1390 4 34.803 23.1301 30.928 3.64223 -3.31893 2.04139 +1391 4 35.9803 22.5404 31.7512 0.26244 15.2618 -11.5602 +1392 6 36.3065 21.404 25.8788 21.1988 16.3215 -11.4752 +1393 4 35.3711 21.2912 25.8279 -29.04 -8.19979 -7.71966 +1394 4 36.6742 20.6179 26.2596 7.44281 -15.7003 9.85929 +1395 6 13.4865 6.74911 5.29345 -32.6693 78.3701 45.7352 +1396 4 13.9616 6.05619 4.98306 41.5093 -80.328 -47.9816 +1397 4 12.7805 7.00791 4.71674 -14.9335 -5.37764 -13.3979 +1398 6 20.8104 20.4092 13.7653 1.99296 11.0688 -14.7475 +1399 4 21.268 20.4545 14.5989 11.9976 -3.76106 7.6647 +1400 4 19.8959 20.3184 13.9984 -15.4264 -4.27358 -1.02469 +1401 6 20.3637 29.125 1.38742 -7.39452 3.20569 15.6829 +1402 4 20.6257 29.8678 1.97015 -13.6171 -7.9879 -3.97808 +1403 4 19.4728 28.7955 1.69287 22.5847 10.4694 -9.78123 +1404 6 50.8792 13.1212 37.2655 -4.22961 23.9091 37.9372 +1405 4 51.3893 12.5589 37.8771 -2.47029 4.54984 -9.0483 +1406 4 50.5869 13.8674 37.8656 5.03029 -21.5284 -25.2034 +1407 6 33.9282 34.1694 20.494 -12.758 16.9363 4.62304 +1408 4 33.9505 34.3661 19.5368 -1.52487 0.481952 13.5649 +1409 4 33.2327 34.7631 20.901 14.0918 -19.53 -17.3949 +1410 6 26.2111 28.0581 27.5584 -15.6012 -12.4051 -9.62147 +1411 4 26.6887 28.3319 28.3498 -5.67664 4.83839 -0.885474 +1412 4 25.2376 28.0657 27.7416 20.5709 -1.16679 -1.23567 +1413 6 7.682 21.3042 4.28531 -31.6563 9.11884 52.3302 +1414 4 8.36407 20.9023 3.81015 41.1991 -18.6864 -33.8238 +1415 4 7.19271 21.9105 3.74865 -6.01459 10.7978 -19.2095 +1416 6 22.0049 15.1615 5.91526 -5.59087 32.8095 7.59658 +1417 4 22.5291 15.4011 5.14076 -1.79158 -8.25489 -6.60562 +1418 4 21.8369 14.2416 6.04435 2.97447 -25.4321 -3.26552 +1419 6 21.7136 24.0096 3.8157 22.5859 -13.9702 -11.1371 +1420 4 22.6792 24.1846 3.95073 -20.2229 4.30251 2.28349 +1421 4 21.6957 23.2604 3.18041 -1.04284 4.75891 13.5064 +1422 6 11.5672 23.7812 12.5534 10.6653 17.5289 -0.525849 +1423 4 11.8567 24.7317 12.4283 -11.704 -31.033 2.93832 +1424 4 11.2483 23.6794 13.4494 -5.02459 5.94744 7.15157 +1425 6 32.3679 18.058 29.8144 -2.59991 12.5874 27.6023 +1426 4 33.2958 17.8537 29.9681 1.40206 -2.08885 -2.88861 +1427 4 32.1708 17.8352 28.9168 3.64727 -16.5589 -23.8097 +1428 6 9.27501 12.3901 30.3257 8.89695 -9.73537 -4.18026 +1429 4 8.97738 13.0169 30.9954 -4.04452 2.00113 -0.0309771 +1430 4 10.1278 12.0418 30.6776 -19.7256 9.24572 -11.0885 +1431 6 40.1671 25.9203 9.1352 -31.1658 -6.55029 4.71016 +1432 4 40.7952 25.2818 9.45931 8.36253 -10.0667 -0.250848 +1433 4 40.6474 26.7215 9.01492 17.3912 21.2934 -6.4579 +1434 6 43.1616 32.3487 37.3267 7.45809 -19.2286 11.3512 +1435 4 42.8399 32.8446 36.5586 -11.2032 -5.45956 10.184 +1436 4 42.4733 31.7245 37.6799 8.3011 17.0164 -20.2151 +1437 6 44.0911 6.28198 31.259 8.64406 -6.47735 -33.2401 +1438 4 43.4563 6.84482 31.6606 -21.1773 24.4303 10.8162 +1439 4 44.5952 5.92873 31.9644 15.9286 -14.2375 24.3689 +1440 6 10.2063 18.8787 19.6978 14.6089 -0.63771 -2.74842 +1441 4 10.128 18.3979 20.5267 6.04825 -4.13467 -1.20166 +1442 4 9.36891 19.3219 19.635 -15.0357 8.38504 -1.1225 +1443 6 7.0561 15.5922 15.0299 -16.4573 19.9198 -23.3889 +1444 4 7.18612 15.4783 14.0721 1.05096 2.95086 4.94392 +1445 4 7.41457 14.833 15.4354 13.8635 -34.6267 13.25 +1446 6 24.544 3.4899 27.8655 -14.5565 -8.97091 -7.81951 +1447 4 23.6823 3.28725 28.2588 1.61952 11.0081 14.175 +1448 4 24.3729 3.16547 26.9791 10.0044 -2.74415 -7.35546 +1449 6 54.4109 31.8087 9.71194 -6.99911 23.6955 33.3298 +1450 4 53.8413 31.5567 9.00593 -8.22136 -4.9258 -26.1741 +1451 4 54.0752 32.6964 9.97695 10.2913 -15.383 -7.59421 +1452 6 6.81072 17.0817 36.2069 -39.6649 -0.569341 -18.8672 +1453 4 5.9036 16.7161 36.0961 17.2423 3.35707 18.397 +1454 4 7.03883 17.1994 35.2786 19.8939 2.17194 6.76773 +1455 6 28.6373 7.46216 20.4204 -3.00228 3.72915 -26.9716 +1456 4 27.791 7.71165 20.8314 -1.23568 -3.59083 -7.19581 +1457 4 28.5788 7.67124 19.4449 -3.89686 1.20908 30.1283 +1458 6 17.0427 1.7136 8.36469 -7.39711 4.96373 -17.441 +1459 4 16.9511 0.79552 8.17539 8.34993 -30.6792 14.2707 +1460 4 16.7364 2.03503 7.50962 2.58977 23.9868 7.32556 +1461 6 19.1319 19.334 35.5748 25.2315 11.3156 3.71898 +1462 4 18.4163 18.7293 35.4559 -12.7574 -15.0058 -3.77114 +1463 4 19.9108 18.8059 35.8312 -7.49406 2.79856 2.97864 +1464 6 7.31044 31.3665 13.5876 -12.5896 -10.3186 -18.1643 +1465 4 6.86348 30.5057 13.838 5.41483 30.5465 -8.86898 +1466 4 6.71656 31.9291 13.023 7.05746 -22.9991 7.02109 +1467 6 16.6555 5.24573 12.8486 0.44122 -36.1931 20.2204 +1468 4 17.4189 5.79101 12.9112 23.6003 17.0932 2.01526 +1469 4 16.8511 4.45507 13.4194 -12.0332 11.5633 -21.5138 +1470 6 43.8917 12.7482 34.58 -33.2024 -13.6106 -1.45858 +1471 4 43.9807 13.5999 34.156 2.60816 15.5254 -0.13451 +1472 4 42.9242 12.5381 34.5161 22.3754 -3.96122 -2.5942 +1473 6 42.656 36.4522 28.5282 -7.17959 22.9727 1.13167 +1474 4 42.279 37.3416 28.6522 -7.55712 -15.8866 -0.526154 +1475 4 43.5285 36.675 28.2003 16.3904 -10.8581 0.329061 +1476 6 35.3704 15.0467 6.02622 35.7531 43.3754 17.6476 +1477 4 35.9258 15.8884 5.86958 -26.5611 -35.5954 0.991204 +1478 4 34.7923 14.9488 5.27074 -5.69332 -0.0870189 -10.0798 +1479 6 19.4034 5.85396 6.19026 -42.6676 -37.2433 -25.4755 +1480 4 18.4973 6.11578 6.46985 14.7962 -6.51198 7.73248 +1481 4 20.0178 6.47164 6.48735 29.6225 43.4574 23.1864 +1482 6 29.2636 38.16 6.98139 -51.0091 34.2659 0.167673 +1483 4 28.4794 38.0546 7.56687 16.6219 5.90534 -14.0005 +1484 4 29.8812 37.5458 7.29338 34.0617 -33.3732 10.6718 +1485 6 19.3639 26.1879 8.4772 -1.75021 -19.5484 18.4946 +1486 4 19.3765 25.7536 9.37133 0.505418 11.6152 -20.7618 +1487 4 20.132 25.8039 8.02679 -2.64689 1.58972 6.88257 +1488 6 4.91801 16.6546 6.12902 16.8332 -1.31437 8.04366 +1489 4 5.58152 17.3 5.84506 -6.45866 4.1219 -0.991793 +1490 4 5.39084 15.8022 6.09449 -7.75564 17.9483 -2.53018 +1491 6 6.07873 16.6931 28.0679 20.4204 4.35008 -35.2212 +1492 4 5.19925 16.4426 27.8453 -29.7482 -9.15572 9.47762 +1493 4 6.44387 16.7631 27.1426 -3.77999 2.92972 38.3228 +1494 6 21.7313 29.3584 22.0941 -19.989 26.599 40.0594 +1495 4 21.5191 30.3374 22.0902 3.30888 -28.6715 -0.0155919 +1496 4 21.2646 29.0087 22.9228 20.4195 8.84702 -28.341 +1497 6 24.487 0.545827 12.8459 24.5625 -19.0276 8.44191 +1498 4 24.0381 0.883409 12.0817 -9.22903 10.6064 -10.7293 +1499 4 24.0836 0.980384 13.5911 -6.14963 8.46579 8.44801 +1500 6 18.4109 28.2545 40.3162 -15.9129 36.5713 -32.2972 +1501 4 18.3366 27.7076 41.0573 0.952339 -31.6797 34.0712 +1502 4 19.1875 27.9677 39.8503 10.0284 -2.61836 -5.50219 +1503 6 10.3807 17.4604 21.8947 -1.20821 -16.3296 3.13877 +1504 4 9.80057 16.6779 21.8113 10.8468 3.86983 1.60142 +1505 4 10.0443 17.9356 22.6521 -9.33664 9.03137 6.2204 +1506 6 13.5404 13.3591 39.6327 12.5768 11.767 30.0264 +1507 4 13.9188 14.1992 39.2886 -9.97897 -11.5724 13.3172 +1508 4 13.5464 13.3749 40.6413 1.33606 5.90172 -38.0522 +1509 6 19.5508 26.0247 24.7387 -47.8665 -1.21537 -13.2845 +1510 4 19.6189 25.3328 24.097 -5.62542 -9.91951 -19.3965 +1511 4 20.3649 25.9852 25.1641 45.3739 3.88293 31.7071 +1512 6 8.93445 25.8823 20.0822 -10.4543 -29.9419 8.18251 +1513 4 8.35083 26.4773 20.5043 -33.2288 11.519 27.1484 +1514 4 9.504 26.5029 19.6962 43.6798 16.1155 -28.0388 +1515 6 13.4493 41.2138 30.5102 -4.84662 -36.1256 25.75 +1516 4 14.2597 41.094 31.0483 -5.58856 8.18726 -8.9115 +1517 4 12.8416 40.5025 30.8796 12.8197 27.661 -18.9522 +1518 6 21.1596 21.6794 11.1163 10.7366 20.8259 2.41134 +1519 4 20.9554 20.8709 10.6777 -10.2383 -24.5438 -10.817 +1520 4 21.2276 21.4421 12.046 -2.84377 -3.57945 5.82209 +1521 6 43.5643 10.3136 15.5616 17.5969 -21.741 5.94749 +1522 4 43.2379 9.48961 15.149 2.99942 14.1859 3.68588 +1523 4 42.9802 11.0242 15.3396 -21.8087 10.2132 -10.2755 +1524 6 23.5302 5.07333 12.3088 -23.5628 55.8128 -25.3063 +1525 4 23.4112 4.1923 12.0373 1.19089 -49.3933 -5.08619 +1526 4 23.0178 5.53904 11.5656 24.5614 -12.3881 30.382 +1527 6 9.28539 15.401 4.24759 1.63269 -5.62651 -9.8947 +1528 4 9.02922 16.1115 4.82738 -12.4128 14.4693 4.40189 +1529 4 9.90895 14.9318 4.78697 15.8319 -9.58935 3.85081 +1530 6 26.711 10.8797 17.566 5.43365 -10.3343 -26.0937 +1531 4 26.4818 11.0142 18.4585 -6.06422 3.32013 41.5711 +1532 4 26.8019 11.7518 17.1937 0.341074 3.88847 -5.26754 +1533 6 26.0592 23.5875 33.6794 25.1455 50.9154 21.2543 +1534 4 25.4682 24.0785 33.1024 -8.24785 -6.01089 -9.80751 +1535 4 26.6604 24.3213 34.0779 -26.6739 -38.162 -12.8336 +1536 6 7.57385 10.4949 28.9097 -14.7972 2.07126 0.456687 +1537 4 6.75277 10.5859 29.4011 -5.17598 -12.8295 -3.89358 +1538 4 8.06091 11.2035 29.3139 24.0536 5.38729 3.77373 +1539 6 16.4953 16.9073 24.6459 13.4535 22.6993 31.6086 +1540 4 15.9363 17.7011 24.6942 7.46422 -1.49957 -9.096 +1541 4 16.1467 16.4045 23.9375 -12.5815 -17.1437 -28.632 +1542 6 12.5505 12.7927 0.441559 26.7797 -18.4986 61.4448 +1543 4 12.8902 12.7839 1.42408 -16.6807 15.1369 -51.7767 +1544 4 12.972 11.9767 0.117581 -17.3776 3.59908 -10.4186 +1545 6 6.80454 2.46926 9.04378 10.3033 -16.1572 19.5551 +1546 4 7.05376 2.92505 9.85651 -1.04006 9.78535 -3.84035 +1547 4 7.36555 1.67892 9.06596 -6.07141 -1.3767 -9.09165 +1548 6 28.8788 11.8454 12.005 47.3119 33.3239 7.75537 +1549 4 28.2175 12.4307 11.6211 -4.89696 7.77957 0.00959457 +1550 4 29.7805 12.2922 11.8721 -37.0304 -14.6121 1.30522 +1551 6 44.6756 32.5924 29.7091 -46.8228 -4.47104 18.0754 +1552 4 43.7214 32.9254 29.5641 42.8383 -8.78111 -1.84094 +1553 4 44.558 31.8742 30.3802 4.31467 20.1075 -17.1439 +1554 6 28.6099 15.1189 32.288 -8.09168 -64.7739 -6.10589 +1555 4 29.0591 15.887 31.9855 13.2175 18.1439 -15.8441 +1556 4 29.0109 14.3064 31.825 -10.272 37.9041 18.9788 +1557 6 1.13952 22.1955 33.6303 -59.4889 25.247 28.7943 +1558 4 0.675447 22.8098 33.0333 5.4615 -9.68619 7.91413 +1559 4 1.8611 21.9185 33.1521 52.5767 -22.4691 -40.0321 +1560 6 17.4529 16.8222 9.92046 -20.0761 -24.0842 48.1247 +1561 4 17.9341 17.1517 9.19999 21.5054 13.464 -32.8219 +1562 4 17.9802 16.1035 10.3295 -2.40424 8.44812 -14.2536 +1563 6 18.74 29.8021 14.3918 16.1488 4.65404 69.9188 +1564 4 19.5966 29.6355 14.8679 -24.5899 1.22938 -11.6521 +1565 4 18.9027 29.6655 13.4911 13.4763 -5.12933 -46.2854 +1566 6 39.4106 6.51176 13.0171 8.18439 9.54271 -9.98348 +1567 4 39.7968 7.3217 12.6105 -7.82756 -18.4389 5.68309 +1568 4 39.8965 5.76959 12.6221 -1.11983 7.69721 6.02388 +1569 6 54.1122 38.2735 14.316 -26.3921 15.7841 23.5556 +1570 4 53.5092 38.7211 14.9446 14.1224 -15.8084 0.476194 +1571 4 53.7657 38.6747 13.5269 5.67525 0.359642 -25.5906 +1572 6 7.51656 32.0218 20.9281 34.7748 10.0158 34.1931 +1573 4 7.08362 31.9253 20.1193 -22.6959 2.07513 -43.8223 +1574 4 7.03544 31.4175 21.4603 -12.2713 -14.4046 24.4342 +1575 6 26.9722 15.5137 13.836 8.2831 -9.07996 -12.1546 +1576 4 27.2905 14.6773 14.2204 -10.3825 7.39938 7.42218 +1577 4 26.0228 15.629 13.9568 -6.27371 -3.74993 11.5294 +1578 6 18.3731 16.4369 32.1258 -5.47484 6.15837 -16.1574 +1579 4 18.1737 16.7054 31.2071 -0.945967 -8.38127 9.44724 +1580 4 19.0036 17.0959 32.4159 12.6478 4.85619 3.13766 +1581 6 52.4904 31.6749 23.2282 -45.8236 3.94874 65.5164 +1582 4 52.5054 32.2301 24.055 -6.11863 -14.7847 -21.5508 +1583 4 53.2278 31.9578 22.7624 44.676 11.2926 -39.5338 +1584 6 2.17063 9.69676 28.2025 -10.599 22.0242 17.0864 +1585 4 2.41083 10.574 27.888 12.6445 -0.15763 -12.1006 +1586 4 1.36653 9.91172 28.7063 1.66945 -10.1846 4.32482 +1587 6 32.9295 0.084333 22.579 -26.8721 -17.4052 -13.8633 +1588 4 33.2309 41.109 22.2818 0.690852 17.8844 8.89147 +1589 4 33.6446 0.598803 22.932 23.7791 -0.031599 0.0852179 +1590 6 20.7171 41.5453 38.643 51.9522 19.855 -62.1487 +1591 4 20.0643 41.0408 39.0691 -29.2365 -22.9372 13.5286 +1592 4 20.9788 41.0468 37.7869 -12.0924 18.2625 49.3819 +1593 6 43.2965 24.3242 12.1559 29.4143 27.7167 -28.3716 +1594 4 43.2964 25.2918 12.2975 -10.3211 -14.9579 7.88207 +1595 4 44.0244 24.2792 11.4826 -12.2932 -11.2644 22.4039 +1596 6 22.0333 36.2992 11.8143 -17.8744 11.1706 -5.23693 +1597 4 21.6038 36.9407 11.2131 12.0614 -9.84488 11.7859 +1598 4 22.8639 36.0559 11.3996 4.49067 -2.6397 -1.6843 +1599 6 50.7446 20.5307 30.3299 -19.4296 24.1009 0.394401 +1600 4 50.3769 20.0585 31.0978 -4.60399 -0.499453 -6.82258 +1601 4 50.1204 21.2977 30.1594 19.9431 -26.9935 4.34337 +1602 6 20.8379 3.84934 18.1872 -10.63 2.24574 17.9634 +1603 4 21.6372 4.15439 17.7675 6.81748 4.13844 -2.44268 +1604 4 20.7537 4.31685 19.0447 1.53322 -4.30004 -12.0579 +1605 6 4.001 20.6421 6.99361 -18.7611 -9.71733 3.72301 +1606 4 3.09723 20.6004 6.53941 30.5715 -8.65918 22.3858 +1607 4 4.00786 20.2035 7.89591 -15.2068 14.2544 -28.772 +1608 6 11.948 15.4413 41.4409 9.86263 -45.3449 -5.39948 +1609 4 11.9713 14.4541 41.6361 -2.32711 35.624 3.02695 +1610 4 12.4708 15.4889 40.6181 -5.28805 11.0492 6.42 +1611 6 3.00764 18.5435 38.9252 6.90717 -29.584 40.0663 +1612 4 3.56523 17.7255 38.8717 -9.75827 16.9893 -1.25399 +1613 4 2.92934 18.9138 38.0721 -1.66709 15.3109 -35.9518 +1614 6 8.5978 38.8858 11.3072 48.4025 32.5603 4.46589 +1615 4 9.44036 39.0024 10.7943 -20.5341 -1.07382 9.55064 +1616 4 8.19448 38.1327 10.9484 -22.3544 -46.6733 -17.9601 +1617 6 12.9691 33.9778 38.4933 34.8069 -13.3685 -21.4899 +1618 4 12.6573 33.2385 37.9471 -9.06758 1.22663 10.2849 +1619 4 13.9307 33.983 38.2659 -20.4066 10.3952 14.8996 +1620 6 4.69069 11.9902 6.04709 5.57568 0.955193 2.63183 +1621 4 3.83092 11.6207 5.79405 1.19943 -2.71585 -3.65246 +1622 4 5.36696 11.7708 5.36999 -19.9658 -4.94035 2.87891 +1623 6 10.8381 15.9154 25.2196 -36.4648 2.02786 -4.38258 +1624 4 11.7191 16.2167 25.3262 31.8449 11.9168 5.4517 +1625 4 10.3518 16.6682 24.8476 5.65772 -8.76316 -0.529027 +1626 6 20.7604 3.23767 6.55488 4.15603 28.9608 0.670607 +1627 4 20.2106 2.56517 6.18958 -7.79877 -24.0058 -5.45951 +1628 4 20.2434 4.04703 6.45055 -2.36445 1.41903 2.77062 +1629 6 47.6381 39.1588 31.2153 -11.506 28.7103 -40.9212 +1630 4 46.7125 39.0803 30.8864 16.1685 3.01672 12.9065 +1631 4 48.0161 39.883 30.6238 -10.851 -36.2784 24.6994 +1632 6 8.33868 27.7571 27.6932 -33.938 3.65348 13.4266 +1633 4 7.90796 26.9962 28.1436 6.90464 18.5991 -0.450451 +1634 4 9.05762 27.3551 27.2376 19.8804 -10.068 -12.1598 +1635 6 33.245 40.3099 33.4253 18.3517 22.2199 -28.9554 +1636 4 32.5937 41.0038 33.2194 0.94932 -12.4457 9.89811 +1637 4 33.9479 40.492 32.7526 -7.59275 -9.33057 17.0692 +1638 6 24.5058 34.6327 27.2588 -1.70215 14.4876 -27.3243 +1639 4 24.8356 35.5409 27.0166 -5.53884 -24.0927 13.0812 +1640 4 24.1351 34.315 26.3934 7.47117 3.95694 29.9195 +1641 6 13.3256 36.76 35.7403 23.371 22.3884 -21.319 +1642 4 14.292 36.6204 35.8687 -19.0607 -2.42845 14.454 +1643 4 12.8134 36.0651 36.1242 -8.79549 -23.1532 9.33092 +1644 6 34.0568 20.1616 33.2139 18.2744 1.49148 -3.34215 +1645 4 34.901 20.3965 32.7524 -27.9907 10.0382 9.43414 +1646 4 33.5726 20.9405 33.5892 13.555 -8.0917 -8.63642 +1647 6 22.8329 33.5616 31.6214 -12.6844 15.5573 -21.5595 +1648 4 23.5755 34.1858 31.5969 1.53708 -3.14405 -0.637663 +1649 4 23.0292 32.8658 32.2325 13.4469 -12.4025 17.113 +1650 6 23.7434 2.42786 19.8498 9.49596 22.5629 12.9133 +1651 4 24.532 1.90722 19.7117 15.1933 -8.07802 -2.32773 +1652 4 23.0629 1.99408 19.3682 -23.4605 -15.8437 -14.4607 +1653 6 10.59 1.63974 20.5169 -0.95575 -6.83071 6.14558 +1654 4 9.98705 1.03236 20.0473 7.71399 2.84727 3.14747 +1655 4 10.6246 2.47233 20.0276 -8.35822 1.7372 -3.87231 +1656 6 6.50082 24.8628 7.81243 5.63459 3.09475 -4.38693 +1657 4 7.40706 24.9537 7.44087 -14.825 -10.0154 1.3351 +1658 4 6.01351 24.1359 7.38457 10.3118 5.93376 -6.27471 +1659 6 54.7907 32.5298 25.4601 2.42441 14.1538 -12.299 +1660 4 54.0693 33.194 25.3949 12.697 -15.3913 -0.923548 +1661 4 0.387469 32.6052 24.6546 -22.4501 -0.197402 25.3904 +1662 6 6.24565 20.1804 28.9699 -20.0835 16.2671 13.5362 +1663 4 5.37616 20.2206 28.5173 17.3942 -4.89439 1.50138 +1664 4 6.85708 19.7029 28.4106 5.94408 -11.9876 -6.03836 +1665 6 50.061 21.6087 11.3404 -11.515 44.0552 -42.0488 +1666 4 50.9725 21.751 11.0493 2.56545 -3.3262 -1.97817 +1667 4 50.0662 20.9568 11.9903 8.13397 -42.2403 36.0281 +1668 6 43.4741 33.5215 19.648 39.1267 -7.16957 -40.9914 +1669 4 43.8052 33.5504 20.5247 -1.27694 2.64583 28.8889 +1670 4 42.5461 33.5822 19.6063 -36.855 5.29583 12.3512 +1671 6 30.8225 7.19458 41.0729 -33.0718 18.8928 10.1641 +1672 4 30.0173 7.64992 40.6345 32.3343 -18.9847 22.962 +1673 4 30.7853 7.47469 0.131591 -1.52838 -8.42988 -38.7943 +1674 6 12.1264 25.8478 11.0965 -41.5825 -1.76886 -24.0951 +1675 4 11.2804 25.9828 10.5746 22.2453 -8.09118 27.7312 +1676 4 12.6111 26.6214 10.8799 25.9351 22.819 -1.42381 +1677 6 47.8207 5.82713 17.7363 28.7614 -16.7343 -8.46055 +1678 4 48.0335 5.15295 17.0353 -2.74159 24.5551 13.4979 +1679 4 48.6986 6.12754 18.0988 -19.3132 -4.26463 -8.98138 +1680 6 35.1697 12.9074 16.5814 -26.6969 23.1645 14.7724 +1681 4 35.331 12.9801 17.5341 9.94288 -5.95548 -5.31324 +1682 4 34.5116 13.6489 16.4838 18.7069 -22.8028 -11.189 +1683 6 10.4746 10.6344 33.9856 -30.1195 -20.4446 -6.31426 +1684 4 10.7944 11.3866 34.5009 -4.55531 -6.56386 0.452866 +1685 4 9.59186 10.377 34.349 25.6427 10.4215 -3.60637 +1686 6 9.86976 7.46809 9.66723 13.2706 -15.2427 -11.6817 +1687 4 9.07254 8.00079 9.6953 0.322066 10.4083 -1.78771 +1688 4 10.1027 7.29929 8.72005 -15.6005 8.2826 19.6359 +1689 6 11.1498 9.5629 29.1446 -4.60031 -6.3451 3.75047 +1690 4 10.6862 9.26798 29.9509 5.10767 2.07156 -10.4371 +1691 4 11.3249 8.76682 28.6116 2.75639 0.845127 6.4689 +1692 6 46.3982 12.7571 37.8973 13.0728 8.65129 -14.0384 +1693 4 46.6651 13.0033 36.9771 -6.5436 -6.98702 17.4091 +1694 4 46.8422 13.384 38.4935 -4.33131 -5.25976 0.421567 +1695 6 4.7745 19.0249 15.9997 -22.3762 2.96494 22.3523 +1696 4 4.16029 19.0173 16.7572 4.82074 7.85299 -8.34635 +1697 4 5.51792 18.5695 16.4006 17.242 -3.98645 -13.636 +1698 6 50.2756 39.8187 19.3535 -48.7732 -19.7782 -8.19609 +1699 4 50.1357 39.0812 19.9713 14.3147 6.83039 4.1366 +1700 4 49.4547 39.7468 18.7938 35.5854 8.27631 5.22634 +1701 6 3.57022 23.2982 26.3116 -7.21736 12.7853 -4.33091 +1702 4 3.04677 23.327 25.4841 2.15403 -9.28995 15.8001 +1703 4 3.1589 23.9918 26.8774 3.27351 -16.4313 -7.87876 +1704 6 43.3323 18.2357 20.5099 -9.76971 -1.121 -6.56922 +1705 4 42.7632 18.9863 20.7177 2.34101 2.93749 0.115163 +1706 4 43.9096 18.122 21.2711 1.48233 -4.92166 7.17918 +1707 6 14.4939 41.5272 19.7194 7.33174 -3.95938 -8.98841 +1708 4 13.9791 41.768 20.4704 -25.804 7.49044 14.4407 +1709 4 15.35 41.4773 20.1189 24.9681 -5.23262 -6.74673 +1710 6 29.2751 29.8624 26.915 55.5011 14.3278 -64.7852 +1711 4 29.462 29.6739 25.9095 -28.0317 9.76644 54.5148 +1712 4 30.1137 30.3565 27.1616 -29.5885 -20.0698 8.89328 +1713 6 6.32585 26.1455 11.5441 3.18215 15.5722 27.8672 +1714 4 6.22913 25.7559 12.4173 -5.87839 -9.43723 6.04013 +1715 4 6.88652 26.9071 11.7431 3.72153 0.148286 -16.8953 +1716 6 27.6581 9.23325 15.2376 24.6795 20.4415 1.81178 +1717 4 28.3906 9.86787 14.9946 -20.7277 -22.2866 6.02651 +1718 4 27.7257 8.49599 14.6233 3.42822 -3.8556 -2.27597 +1719 6 29.7826 38.0629 17.0951 -21.7625 -1.10982 -31.3954 +1720 4 29.5447 37.2807 16.5438 11.5646 7.7876 16.1146 +1721 4 29.1666 38.7512 16.7768 9.10566 -6.75007 12.2127 +1722 6 52.2237 28.7307 4.26632 40.7154 12.5569 -19.536 +1723 4 53.094 28.6942 3.75761 -25.982 6.02481 23.1744 +1724 4 51.8384 27.8718 4.17524 -3.40498 -27.0863 -4.04919 +1725 6 17.1651 16.6761 6.10093 10.0081 29.999 -15.4838 +1726 4 17.0645 17.5224 6.60658 -3.46995 -23.4179 -4.25622 +1727 4 16.9429 15.9406 6.65512 -3.52922 -13.7209 19.1007 +1728 6 36.6584 7.55275 33.426 1.51046 -27.4434 34.6673 +1729 4 36.0562 7.00422 33.9909 9.38132 12.247 -13.9906 +1730 4 36.0891 7.78594 32.7139 -15.8398 12.8789 -25.2624 +1731 6 26.1693 3.13272 9.58463 26.4836 36.1065 -53.3475 +1732 4 26.5189 3.61335 10.3026 12.8321 10.8542 33.1136 +1733 4 25.6805 2.43597 9.90138 -37.6231 -51.1462 30.1839 +1734 6 1.19232 17.1076 33.1734 0.722887 26.1228 -9.87087 +1735 4 1.0219 17.7977 32.4875 3.44775 -13.3597 11.6369 +1736 4 0.89275 17.4757 34.0242 -0.842403 -4.58413 -3.86686 +1737 6 29.175 10.1805 5.37687 2.48705 -7.47299 -1.58449 +1738 4 28.5307 10.3443 6.0806 2.54341 -1.49901 -0.102048 +1739 4 29.6529 9.35261 5.56356 -13.9845 3.47491 -0.693848 +1740 6 9.21964 21.135 0.193729 30.6013 -8.57211 -16.2038 +1741 4 9.93935 20.7152 41.5745 -5.21063 7.9265 20.924 +1742 4 8.4582 20.7874 41.6647 -18.4316 -1.36421 1.54976 +1743 6 7.41915 26.897 34.8578 6.273 24.0322 40.4596 +1744 4 7.07209 27.1094 35.7714 11.2799 -9.18849 -34.7736 +1745 4 6.87885 26.1925 34.5434 -18.5272 -22.724 -11.5995 +1746 6 18.6237 10.1563 3.02822 -55.9716 37.9013 1.68891 +1747 4 17.9823 9.44023 2.87563 14.9297 4.34306 1.98909 +1748 4 18.009 10.9755 3.18254 40.8652 -32.8317 -2.61569 +1749 6 13.1455 21.2337 25.2154 -14.3081 5.93545 -14.9534 +1750 4 12.8153 21.6822 24.4216 9.6722 -4.26313 4.93127 +1751 4 12.7862 20.3541 25.1726 -3.49479 -14.4912 -0.313259 +1752 6 4.91031 24.4198 40.532 -13.7809 -26.5024 -53.169 +1753 4 5.65778 24.4539 41.0894 26.3299 12.2697 26.6549 +1754 4 5.26856 23.9753 39.7091 -18.4358 16.5303 24.5031 +1755 6 54.7198 6.2862 9.93073 18.558 2.67796 -18.7732 +1756 4 54.1336 6.00192 10.611 -15.308 -5.80798 23.6242 +1757 4 0.005563 7.17106 10.1764 0.43073 7.36928 5.10877 +1758 6 51.7604 16.6436 19.3877 -20.3234 -7.55047 -14.8495 +1759 4 51.6779 16.1639 18.5383 1.1676 14.9854 4.84802 +1760 4 52.2077 17.4816 19.2574 16.3674 3.30585 -9.00164 +1761 6 38.6218 2.96001 13.0988 15.7387 3.67705 55.5859 +1762 4 38.6299 3.43096 13.9849 -4.06073 -12.9308 -23.724 +1763 4 38.2169 3.56793 12.5083 -12.8186 19.7945 -24.9943 +1764 6 19.4471 35.7007 9.61167 2.35324 -8.95281 6.35471 +1765 4 18.8335 36.2871 9.19379 -17.9936 2.63552 -14.7984 +1766 4 18.9495 35.3837 10.3842 8.56204 6.47345 -9.11173 +1767 6 46.9457 37.6212 25.7021 -15.6754 4.57489 10.5165 +1768 4 47.0239 38.0262 24.8354 11.6036 -0.197794 -10.4287 +1769 4 47.7281 37.1166 25.9279 8.14222 -0.129186 -6.11913 +1770 6 20.0249 17.2708 14.7582 9.34392 -2.11639 -6.02108 +1771 4 19.1723 17.4786 15.1706 12.7461 -0.873648 3.80655 +1772 4 20.7009 17.0069 15.4035 -13.3418 2.74043 0.572405 +1773 6 24.7358 29.2923 3.78206 18.5642 -33.4808 -47.1325 +1774 4 24.7422 28.3915 3.3709 -13.1038 11.8323 28.3161 +1775 4 25.3506 29.6775 3.14782 -2.77927 21.1078 10.4189 +1776 6 3.43141 8.92567 6.82668 25.8011 -1.75535 29.9445 +1777 4 3.08486 8.82716 7.75964 16.0017 4.22665 -30.6726 +1778 4 4.42441 9.10783 6.89545 -42.5611 -5.30748 1.54274 +1779 6 17.4891 30.59 19.7026 37.1524 -11.5388 -6.241 +1780 4 18.4343 30.3591 19.4199 -38.2372 10.1448 10.4771 +1781 4 16.9657 29.7875 19.5831 -4.14236 3.18225 -9.29444 +1782 6 13.2748 16.1833 39.0603 8.39615 -10.6604 2.01333 +1783 4 13.778 16.9491 39.3364 8.93523 3.59341 7.63718 +1784 4 12.5498 16.5465 38.5646 -17.693 7.52452 -10.3405 +1785 6 23.8419 27.9652 11.5971 -29.0622 15.8949 5.8355 +1786 4 23.0433 27.5239 11.9581 15.8216 -1.64981 -8.50246 +1787 4 23.6687 28.8945 11.8451 9.38175 -9.8305 -3.59643 +1788 6 14.4582 24.411 21.2251 -13.2323 27.0215 19.0701 +1789 4 13.9163 25.2229 21.3861 13.2503 -9.35589 -12.2275 +1790 4 14.348 23.9323 22.0593 -1.27999 -3.95586 -5.82862 +1791 6 46.6209 15.1404 22.2877 -21.0909 8.30909 34.5316 +1792 4 45.8336 14.7024 21.9608 7.3328 -3.88381 -14.3297 +1793 4 47.2246 15.4169 21.6106 10.5055 -5.27886 -22.0515 +1794 6 19.1453 29.7169 11.8746 -27.0123 -18.8736 -35.9167 +1795 4 18.7667 30.5363 11.5796 10.8323 29.6783 4.39578 +1796 4 18.5214 29.1838 11.3275 23.3568 -13.7991 20.8336 +1797 6 36.9132 18.8016 27.615 -17.0652 -23.8487 30.8874 +1798 4 36.4034 18.4868 26.8464 6.26881 1.65463 6.80847 +1799 4 36.6041 18.1666 28.3506 10.215 31.7365 -33.4968 +1800 6 35.8839 17.5137 25.5036 -5.81764 30.7264 -16.7466 +1801 4 36.5665 17.9094 24.9 -10.7703 -22.5287 9.19997 +1802 4 35.9135 16.5474 25.44 8.68204 5.15754 -2.43364 +1803 6 8.04468 41.8981 31.5366 26.4021 9.77217 -3.38911 +1804 4 8.66886 41.284 31.9946 -24.4733 15.0027 -13.0466 +1805 4 8.60227 0.704634 31.1522 -11.4596 -14.2431 6.13083 +1806 6 31.7024 34.8356 17.9299 26.5575 -27.0845 -4.88708 +1807 4 32.6196 34.4986 17.7931 -22.3662 0.836155 -3.84042 +1808 4 31.9071 35.6664 18.3392 -5.09232 26.8034 6.09861 +1809 6 22.0993 41.0535 5.13739 10.0927 40.3608 -89.4928 +1810 4 22.1435 40.6782 5.94278 2.96748 -46.7441 88.004 +1811 4 22.8097 40.6452 4.60918 -8.49191 2.25551 6.5005 +1812 6 11.6188 5.17183 29.5438 -37.4391 -17.3681 45.4318 +1813 4 12.0782 4.3477 29.7115 12.4576 1.56532 -11.0695 +1814 4 10.8376 5.06958 30.1835 21.3256 14.0691 -33.8944 +1815 6 13.0142 9.45267 21.0738 -17.3871 -39.5803 -33.4019 +1816 4 13.648 9.91302 21.5572 37.1542 33.3127 26.6408 +1817 4 13.4951 8.71823 20.6397 -14.9934 11.5246 2.17133 +1818 6 12.4259 4.16416 0.171584 25.5917 58.0572 -18.9009 +1819 4 12.7038 3.75631 0.988868 -0.121161 -3.62646 8.37405 +1820 4 12.9914 5.02921 0.073462 -27.1162 -49.1387 2.0493 +1821 6 45.1548 14.6294 28.1056 43.5869 -15.7342 -2.79686 +1822 4 45.3799 14.9442 27.2254 -14.4652 2.82802 -6.08545 +1823 4 46.001 14.1543 28.294 -26.1128 6.03561 5.66217 +1824 6 52.5819 19.2522 0.880939 -13.6546 -24.4625 3.21793 +1825 4 52.4967 19.3157 41.8353 6.16951 -6.72877 -2.3034 +1826 4 52.7342 20.1258 1.1855 8.55196 28.2584 6.16427 +1827 6 0.17636 18.5769 30.5692 -13.5341 -21.3209 11.3545 +1828 4 0.97347 18.6538 30.0344 3.16555 8.74201 -0.550561 +1829 4 54.7381 19.4288 30.6755 1.51483 11.9419 -1.05075 +1830 6 17.6474 28.1849 1.96582 -3.95698 7.79984 2.09024 +1831 4 17.0036 28.8884 1.72628 7.01161 -11.1903 7.18073 +1832 4 17.5665 28.0879 2.93205 1.48476 5.36119 -8.9874 +1833 6 22.5179 30.1562 5.01973 -0.557011 13.5756 -11.2394 +1834 4 23.053 30.1464 4.21842 7.71181 1.56353 5.86697 +1835 4 22.1417 29.2826 4.9966 -11.5089 -8.75783 6.0437 +1836 6 11.3992 8.80614 17.6425 18.8049 17.2909 -5.92301 +1837 4 12.0044 8.1818 18.0403 -8.94801 -14.7479 17.6102 +1838 4 12.0653 9.44286 17.3244 -18.8797 1.15675 -4.46111 +1839 6 32.2825 3.5901 26.8335 38.6865 42.7422 0.354813 +1840 4 31.9744 3.38447 25.9652 -16.937 -9.17442 -22.5821 +1841 4 32.8531 4.41036 26.697 -18.7333 -32.0278 -1.10411 +1842 6 26.8283 37.1448 15.664 9.9544 44.9512 -6.81835 +1843 4 26.832 37.6522 16.5019 -4.80771 -22.2764 -7.00776 +1844 4 26.708 36.2069 15.7377 -4.77442 -21.1488 11.5765 +1845 6 22.9466 3.40402 22.281 26.551 -3.46013 -1.27592 +1846 4 23.3626 3.00539 21.4748 -15.0613 6.75 14.6032 +1847 4 23.702 3.67884 22.8406 -14.5661 -4.86975 -12.1571 +1848 6 14.6187 28.2219 5.2011 12.2375 -1.31522 5.54773 +1849 4 14.146 28.1316 4.37141 -5.71124 1.87741 -8.30492 +1850 4 14.2863 29.0052 5.66137 -0.824291 -0.470469 -2.06805 +1851 6 20.2555 37.1856 16.5486 -24.9193 16.4856 21.7008 +1852 4 21.0596 37.4718 16.144 26.6499 6.5165 -11.4453 +1853 4 20.1477 37.8155 17.2956 -4.48599 -12.7862 -6.90992 +1854 6 17.9469 28.5629 23.8891 26.0841 -15.2841 -12.8531 +1855 4 18.7956 28.2639 23.4837 -20.5944 5.95667 14.8805 +1856 4 17.3322 27.8283 23.7208 -3.07308 9.52654 -1.59768 +1857 6 33.6454 24.2344 25.2281 6.08515 -19.3492 9.67379 +1858 4 33.7229 23.2583 25.1621 -7.7165 13.5894 -11.682 +1859 4 33.9838 24.3464 26.1231 0.527101 9.69022 -3.14208 +1860 6 9.99248 17.6305 2.22889 -2.94775 -31.1618 -12.577 +1861 4 10.7668 17.5307 1.6348 -7.17319 1.58445 12.7603 +1862 4 9.8062 16.7546 2.64219 6.61617 15.6433 -4.64734 +1863 6 24.3378 36.7975 8.92134 10.0949 -17.5556 18.6285 +1864 4 24.0798 37.5812 8.46711 -7.4438 24.0622 -5.98172 +1865 4 24.7733 37.0584 9.7453 -6.84359 -4.10885 -5.58351 +1866 6 14.3929 4.30304 27.7402 56.7365 -3.53996 19.7179 +1867 4 15.3546 4.44499 27.4586 -37.3153 -7.57895 7.00929 +1868 4 13.8272 4.37832 26.9899 -16.116 5.01688 -19.8092 +1869 6 13.2096 25.4586 35.3298 -3.87145 -6.51473 -10.8119 +1870 4 13.1476 25.2267 36.278 -1.83966 -3.78777 -13.8323 +1871 4 12.5545 24.9939 34.7684 5.09589 5.85633 19.2997 +1872 6 43.7315 33.1816 24.4051 17.2004 -9.02075 24.8986 +1873 4 44.3591 33.0681 25.1678 -20.1541 -6.26738 -17.3644 +1874 4 44.1096 33.9146 23.9227 -1.6352 8.32092 -8.69406 +1875 6 6.97009 30.4077 7.13769 23.121 1.43384 34.0809 +1876 4 6.71282 29.9591 7.9596 7.06976 3.62274 -2.26904 +1877 4 6.20421 30.2819 6.61977 -27.9511 -2.76807 -27.2062 +1878 6 44.437 39.4145 21.7835 -9.43682 11.6365 -18.5611 +1879 4 43.878 39.1032 21.0489 1.92512 -11.9494 17.5009 +1880 4 44.878 40.1639 21.3648 8.44417 -6.89071 6.17346 +1881 6 1.1648 16.4475 24.9778 -2.61131 5.39938 13.1681 +1882 4 1.07525 17.0286 24.1819 -7.88043 -13.0173 22.3573 +1883 4 0.434843 16.5677 25.6378 18.4556 1.9359 -28.7216 +1884 6 8.16988 33.8361 10.6637 16.6829 23.9256 47.7562 +1885 4 8.49559 33.5478 9.83195 -4.50358 -22.2449 -29.7436 +1886 4 7.35799 33.4028 10.9227 -18.4601 -13.1254 -8.86092 +1887 6 45.3716 15.8699 40.491 -6.36942 -3.03704 -2.15917 +1888 4 44.5133 15.7719 40.0601 4.63234 -6.98635 -0.416374 +1889 4 45.243 16.6248 41.0649 5.7116 1.92459 5.42472 +1890 6 38.7776 4.29245 15.9056 11.0795 0.30753 4.41463 +1891 4 39.6766 4.00679 16.0952 1.69097 -2.92337 -3.33067 +1892 4 38.5504 4.73291 16.7401 -7.14778 -2.92142 -9.36231 +1893 6 21.0846 9.20759 23.9691 5.60032 -0.18462 4.18544 +1894 4 20.9445 8.65571 23.1711 -3.69603 16.8592 7.46004 +1895 4 20.5672 10.0363 23.9442 1.93643 -14.5945 -11.3561 +1896 6 6.46938 36.1391 20.0069 4.0004 4.10087 4.13062 +1897 4 5.99357 35.3124 19.8297 -2.3473 7.0562 -2.30419 +1898 4 7.3052 35.893 20.4098 -0.600933 -5.92452 -3.30983 +1899 6 17.7588 23.4635 11.2444 16.528 -28.2646 53.7307 +1900 4 16.9432 23.8548 11.0264 -32.805 26.4079 -23.7501 +1901 4 17.621 23.3206 12.2167 9.32529 -0.814156 -28.2078 +1902 6 2.23938 39.2705 23.5372 32.4488 -19.3396 -21.3039 +1903 4 2.96143 39.1072 24.212 -19.8533 -4.03587 -26.9428 +1904 4 2.57592 39.0525 22.6024 -11.4643 11.6849 46.2914 +1905 6 21.7189 10.3135 3.08585 -2.90529 19.7604 61.578 +1906 4 21.843 10.1221 2.19424 -0.974385 -17.6276 -55.1642 +1907 4 20.7734 10.4085 3.28686 2.80557 -4.86174 -11.6796 +1908 6 13.3371 37.6485 26.8148 34.7445 -2.08205 -3.58175 +1909 4 12.7942 37.01 27.2655 -5.666 -15.7112 8.11946 +1910 4 14.1995 37.1812 26.5945 -31.1056 12.6209 6.4215 +1911 6 45.679 9.86525 8.82671 -1.22844 -5.97168 -0.0165319 +1912 4 45.3204 9.57969 7.98479 1.29945 7.51218 -9.52666 +1913 4 45.2548 9.27624 9.44517 -6.37871 -3.09075 9.62419 +1914 6 39.8117 32.343 29.5858 -3.04799 14.0722 -9.88422 +1915 4 39.6223 31.4471 29.2796 3.58631 -7.81261 7.71305 +1916 4 40.3439 32.3214 30.3816 0.770365 -10.1242 2.16071 +1917 6 39.1301 32.1592 8.96473 45.9624 -7.76569 -23.2306 +1918 4 39.6852 32.0596 8.1252 -31.4186 4.60772 35.1501 +1919 4 38.2007 32.2042 8.75798 -9.66602 0.778467 -8.76952 +1920 6 29.7501 11.3103 40.3404 42.6438 -12.6008 -10.1865 +1921 4 29.0692 10.6634 40.5326 -1.99158 -8.72077 -0.363163 +1922 4 30.6164 10.7842 40.3158 -34.6338 15.486 -0.0451708 +1923 6 24.8345 19.8801 29.8412 -7.59088 37.7695 16.0848 +1924 4 24.9026 19.0378 30.268 -1.65451 -21.4471 9.48031 +1925 4 24.5694 20.5293 30.547 8.64688 -23.6335 -15.2845 +1926 6 50.0799 29.4689 2.86832 11.3398 7.37373 -14.0975 +1927 4 50.7937 29.3382 3.51213 -5.95266 6.62042 -8.33887 +1928 4 50.5172 29.4209 1.98721 -16.9062 -3.16045 21.5768 +1929 6 26.3158 13.2487 37.9516 44.6834 6.62304 1.7852 +1930 4 27.2667 13.2121 37.7291 -19.4356 -10.4808 -19.3263 +1931 4 26.4654 13.336 38.8817 -25.2145 10.5198 25.1195 +1932 6 24.3285 13.817 16.1492 -2.87417 -29.0242 -9.8062 +1933 4 24.8278 14.0306 16.9324 2.95884 13.8503 11.1204 +1934 4 24.1796 14.5912 15.6032 1.91347 13.6823 2.96602 +1935 6 21.9624 25.0824 8.00452 15.4008 12.078 14.6814 +1936 4 22.598 25.7039 7.58094 -6.50256 -15.9793 3.04336 +1937 4 22.4506 24.6482 8.74092 -7.92214 9.81208 -17.5113 +1938 6 50.1646 25.295 29.0323 7.20414 -13.325 -13.2678 +1939 4 50.9752 25.188 28.522 -3.46618 -9.57224 -11.582 +1940 4 50.4808 25.9292 29.6536 -4.58067 20.151 23.6328 +1941 6 23.186 6.81871 7.63171 8.52809 43.4321 -4.70249 +1942 4 24.005 7.36604 7.81791 -26.2659 -19.6382 -4.15731 +1943 4 22.4749 7.49932 7.50679 12.9101 -23.886 0.0924589 +1944 6 6.93738 5.85096 20.8328 -1.25739 23.0019 -5.42089 +1945 4 7.49016 6.65136 20.6793 -8.05782 -22.0664 2.33926 +1946 4 6.43567 5.73489 20.0135 6.68134 -11.6114 -0.0369962 +1947 6 25.4027 39.7503 23.9523 -6.31967 32.2782 -31.5462 +1948 4 25.6215 38.8259 24.0292 3.86532 -10.8289 -5.32001 +1949 4 25.5293 40.0494 22.9984 1.78505 -20.5244 33.6821 +1950 6 10.8465 30.682 2.12076 -14.9417 -4.95607 29.3443 +1951 4 9.91334 30.8811 2.27771 3.65307 -4.25506 9.47201 +1952 4 11.0492 31.2188 1.38489 10.4343 12.2811 -36.8692 +1953 6 23.0846 40.5263 40.0577 -14.1833 12.856 -13.2149 +1954 4 23.7732 40.7716 39.4116 -4.4893 -4.99974 3.24897 +1955 4 22.2685 41.0049 39.7737 14.5189 -12.3092 -2.05606 +1956 6 29.2062 28.3669 37.5673 -46.9973 46.4688 -26.4511 +1957 4 28.2092 28.447 37.3765 47.4284 -5.55714 9.99444 +1958 4 29.3363 27.5265 37.9547 9.31284 -31.0764 15.334 +1959 6 1.86163 12.1711 18.0765 -5.91003 5.49035 -5.71632 +1960 4 2.55659 11.9166 18.6527 25.6221 -14.4574 8.12849 +1961 4 1.26079 12.5379 18.7153 -20.6967 6.08864 -3.03965 +1962 6 35.8475 14.1052 8.57203 -21.6385 -0.893463 -33.3774 +1963 4 35.1968 13.4152 8.63145 -9.00219 -13.9675 31.2536 +1964 4 35.5915 14.3843 7.67264 23.8052 12.2531 2.11843 +1965 6 9.47935 39.8135 37.5891 59.0759 6.31763 -30.1219 +1966 4 10.4266 39.6693 37.2666 -35.8633 -8.68454 26.4626 +1967 4 9.26489 40.5592 37.0217 -20.4655 -4.29881 5.22341 +1968 6 3.55142 30.3339 19.2713 -4.86381 -1.52132 15.3498 +1969 4 4.33638 30.9045 19.2209 2.57405 -7.87202 3.73908 +1970 4 3.61239 29.7873 20.0935 6.99099 14.0083 -17.3235 +1971 6 36.3358 32.3745 17.56 -88.747 -21.2483 -18.3477 +1972 4 37.1123 32.7301 17.855 71.5568 29.0637 22.2427 +1973 4 36.4955 31.7908 16.8209 7.92507 -6.87638 -5.35096 +1974 6 22.0663 24.5107 41.4102 10.2987 16.3962 12.7497 +1975 4 21.8202 25.2352 0.099599 7.35269 -2.74787 -1.24985 +1976 4 21.4331 24.5495 40.7007 -15.7672 -0.145359 -12.6123 +1977 6 45.7559 15.6146 11.6534 9.54961 -0.52573 -11.8143 +1978 4 46.6616 15.9476 11.7359 -2.85604 3.39399 3.95489 +1979 4 45.8337 14.6574 11.6049 5.18085 -12.4794 -2.56515 +1980 6 22.3677 20.3608 16.0248 -8.43349 0.762232 -3.33301 +1981 4 21.8453 20.4382 16.8206 -16.1556 -9.64869 10.2413 +1982 4 23.0114 21.0388 16.1556 20.3116 20.3082 3.24798 +1983 6 25.8272 25.7408 18.9039 -4.38174 23.1082 -8.64826 +1984 4 25.2526 26.4897 18.6396 10.1677 -11.9346 2.39614 +1985 4 25.327 25.3554 19.6213 -1.60311 -10.6753 3.35926 +1986 6 35.3217 34.2027 33.2895 -15.2368 -41.9721 4.95923 +1987 4 35.4982 35.1152 33.2737 3.10328 43.0158 -1.14622 +1988 4 34.4946 34.1251 33.8 0.780353 -3.85018 -10.6306 +1989 6 39.2773 17.1161 17.3873 -13.1248 -32.2738 -8.05101 +1990 4 39.9918 17.6798 17.5739 28.094 23.6652 8.23643 +1991 4 38.688 17.6273 16.829 -11.1713 3.07886 5.75329 +1992 6 0.390078 14.9382 21.7871 11.1367 4.76555 -0.935352 +1993 4 54.4387 14.8735 21.5807 -4.47162 2.48431 -1.07762 +1994 4 0.539841 14.2564 22.4568 -0.558284 -6.24417 -4.29591 +1995 6 15.9777 23.2264 17.7728 8.65625 13.1041 -6.34263 +1996 4 15.4566 22.9884 16.9791 5.52796 1.00784 5.82867 +1997 4 16.2806 24.159 17.6616 -10.6082 -13.1932 5.11686 +1998 6 5.23931 11.1231 17.5575 35.8701 -10.5445 17.9772 +1999 4 4.9182 10.2425 17.6538 -30.0926 -10.858 -8.95801 +2000 4 6.0864 10.9521 18.0214 -7.64643 27.0942 -5.06777 +2001 6 9.32885 36.7248 13.2722 18.9931 -22.2768 -8.23823 +2002 4 9.60165 35.7781 13.2295 -3.69965 14.6724 -0.704445 +2003 4 9.76236 37.1699 12.5317 -7.58045 -2.70049 0.515103 +2004 6 25.4778 33.5648 0.584885 -10.5355 67.2754 -12.4068 +2005 4 25.5984 34.5208 0.879361 -11.6997 -30.6233 -9.64051 +2006 4 26.086 33.1118 1.1181 20.4991 -31.2317 29.3626 +2007 6 17.3118 24.383 31.3319 -1.28664 6.54307 -2.76395 +2008 4 17.7194 25.1777 30.9449 -5.40799 -4.17061 0.343513 +2009 4 16.6541 24.6578 31.9842 -4.89885 3.77294 -0.581941 +2010 6 50.5608 32.7082 27.7934 4.54158 -2.94952 -18.7634 +2011 4 50.7453 32.9177 28.6973 0.494052 11.2961 18.8161 +2012 4 49.6536 32.9735 27.676 -15.0266 -0.0998574 -2.84245 +2013 6 2.26734 37.236 16.1173 -6.42813 -12.7591 -21.9136 +2014 4 3.23226 37.3187 16.1136 -7.03488 -2.64717 4.42174 +2015 4 1.90002 37.4962 16.9584 8.86323 8.39289 12.7736 +2016 6 25.781 33.1953 8.40059 -29.5389 -21.3471 9.61313 +2017 4 24.912 33.1588 8.86731 13.6407 4.32372 -10.5279 +2018 4 25.7521 32.4014 7.84509 3.14784 4.30114 -1.53431 +2019 6 24.7803 7.83271 25.42 33.5144 32.018 13.9598 +2020 4 25.5535 8.29724 25.0002 -28.4293 -10.6828 16.5011 +2021 4 24.3491 7.42211 24.7041 -24.9556 -17.4551 -27.4815 +2022 6 44.0168 27.3303 21.5604 -2.1935 -26.0293 -25.9567 +2023 4 43.1804 27.7287 21.7105 -15.5436 25.6402 11.6584 +2024 4 43.7182 26.5374 21.0766 16.4483 6.01939 6.04345 +2025 6 20.8314 32.075 6.72772 34.1297 -23.9008 -4.85338 +2026 4 21.613 31.4679 6.7544 -19.7741 14.5872 -14.4381 +2027 4 20.6476 32.1788 7.6576 -7.69651 14.1485 11.3249 +2028 6 0.619789 26.0994 3.99415 -10.3518 14.1264 10.767 +2029 4 0.887335 25.4928 3.30986 5.36048 -13.1936 -7.97543 +2030 4 1.24971 25.9998 4.71308 0.85353 -1.82089 -1.56654 +2031 6 23.69 0.227417 22.8544 35.0871 1.11343 17.3571 +2032 4 23.3906 1.11513 23.0752 -8.28129 -2.57498 -6.74336 +2033 4 24.6181 0.214091 23.2237 -29.0994 -2.98435 -11.3486 +2034 6 35.6339 26.9438 6.46453 10.8918 50.3879 3.14258 +2035 4 36.2586 27.0344 7.19591 -3.09793 -24.7425 -0.485193 +2036 4 35.6905 27.8753 6.10871 -13.1004 -35.3011 6.52721 +2037 6 50.1792 7.09321 18.6927 -10.3798 0.485236 0.91939 +2038 4 50.7755 7.39768 17.9917 2.23399 -7.26744 -1.07457 +2039 4 49.6856 7.89728 18.8977 2.66313 1.30029 -2.34319 +2040 6 12.4725 14.8259 12.1994 -11.4238 -12.6169 14.8051 +2041 4 11.6664 14.488 12.6556 18.5487 5.78377 -7.93059 +2042 4 12.1518 15.362 11.4889 -6.75978 6.85562 -13.2996 +2043 6 52.4644 22.357 36.3266 1.29806 9.96622 10.4358 +2044 4 51.6029 21.898 36.3064 11.3287 0.910024 -15.7837 +2045 4 53.0734 22.0059 35.6434 -17.6122 -2.36697 5.80151 +2046 6 41.7741 11.4843 39.1248 -4.39753 -8.31887 -97.8346 +2047 4 42.1028 11.6824 39.9378 27.3537 17.7413 77.2645 +2048 4 42.4804 11.7867 38.4877 -22.5072 -9.73773 16.9601 +2049 6 13.8016 22.5118 39.1095 -61.9889 -17.7515 -30.6487 +2050 4 12.8197 22.2903 39.2632 45.6803 12.2331 1.0283 +2051 4 13.898 22.318 38.1378 10.5436 5.15112 27.5343 +2052 6 28.757 19.5278 21.8422 22.1809 -34.574 6.30338 +2053 4 29.5381 18.8977 21.7155 -30.335 22.4331 6.48321 +2054 4 28.5907 19.9346 20.9925 4.65837 4.37905 -10.6157 +2055 6 8.3499 21.6369 36.3971 -4.18721 -6.14707 -6.4426 +2056 4 8.67403 22.5346 36.3601 -3.60933 11.4321 4.1017 +2057 4 7.70004 21.5677 37.1222 1.54916 7.87236 -6.53046 +2058 6 39.9526 23.9745 15.2115 13.6309 -13.3423 -31.903 +2059 4 40.8439 23.5703 15.3899 -24.3155 14.8143 -11.3375 +2060 4 39.7878 23.9253 14.2154 4.70535 3.62281 36.021 +2061 6 8.1527 38.6897 22.5283 9.69445 13.3876 41.2978 +2062 4 7.76273 39.4363 22.0797 -11.7526 5.15604 -12.9046 +2063 4 8.4358 39.1168 23.3873 -5.25998 -17.8667 -18.7912 +2064 6 10.8496 20.1728 28.9641 16.4592 -1.26099 15.6701 +2065 4 9.98954 19.7606 29.0198 -7.88942 -4.93169 1.40711 +2066 4 10.9743 20.477 28.0788 -3.54014 6.836 -18.3013 +2067 6 36.8958 23.8215 41.8184 -11.2791 50.4956 -15.8947 +2068 4 37.6092 23.2626 0.106032 31.5333 -36.7229 14.8491 +2069 4 36.0533 23.398 41.8576 -15.1401 -19.7994 6.87638 +2070 6 23.7844 40.6753 33.3645 25.4398 -8.90266 -26.6636 +2071 4 23.0047 40.9559 33.8219 -17.4738 3.31201 10.6553 +2072 4 23.8864 39.707 33.5122 -4.88896 17.7845 5.86364 +2073 6 4.67086 19.2968 35.4027 23.2175 14.2952 24.1117 +2074 4 5.52557 19.1329 35.8895 -25.1286 -0.194605 -14.6261 +2075 4 4.47498 18.5363 34.8535 5.06934 -11.7578 -4.1199 +2076 6 9.45318 25.7818 10.8943 -12.0967 -8.54473 -2.48434 +2077 4 9.17249 24.8577 10.8042 5.18757 -1.88658 7.00696 +2078 4 8.69489 26.2739 10.5541 4.04726 3.8113 4.64502 +2079 6 27.2856 22.4903 13.6084 -4.27813 -9.26261 -11.4963 +2080 4 27.1477 21.7546 14.2243 0.799228 0.372191 -1.31996 +2081 4 27.4324 22.0688 12.7356 2.14896 10.5831 15.5277 +2082 6 41.0369 18.7679 23.2817 21.3973 -17.1333 -11.6606 +2083 4 40.4805 18.1775 22.7581 -1.93352 7.79722 7.02989 +2084 4 40.5302 19.4817 23.6332 -16.07 12.1618 6.58845 +2085 6 46.4867 28.3511 20.139 19.5633 -2.73425 79.1757 +2086 4 45.7489 28.0125 20.7058 1.11057 9.83041 -23.9354 +2087 4 47.2126 28.3766 20.859 -22.6454 6.05643 -47.0217 +2088 6 14.8422 15.3983 30.0672 9.57922 -13.7488 21.5316 +2089 4 14.7114 15.4303 29.1407 -5.18406 2.12307 -31.6519 +2090 4 14.4223 14.5569 30.327 1.67929 11.6926 7.32181 +2091 6 23.5155 24.7614 35.2027 10.8097 10.1661 11.7756 +2092 4 22.8249 25.3921 35.4883 8.74662 -8.07224 -2.50931 +2093 4 24.264 24.8574 35.8273 -14.1502 1.20627 0.95778 +2094 6 19.9045 24.2066 28.4368 -7.08314 38.6572 -15.5481 +2095 4 20.1199 25.09 27.9887 -7.53461 -31.417 18.3002 +2096 4 18.948 24.2479 28.615 8.77669 -1.27719 -1.90381 +2097 6 45.9703 7.63062 20.2339 -9.12647 -14.8446 45.7383 +2098 4 46.0314 7.87281 21.2057 4.66889 -10.1155 -32.2433 +2099 4 46.2124 8.39508 19.7344 6.23892 21.3693 -9.48098 +2100 6 38.0366 12.4686 8.28298 -82.8488 23.4696 -21.0017 +2101 4 37.3097 13.1608 8.47894 48.7672 -25.4087 1.47773 +2102 4 37.4891 11.9231 7.63396 42.6716 2.94367 19.7224 +2103 6 46.9352 18.181 8.45984 -29.3266 9.95329 16.0714 +2104 4 46.1825 17.5598 8.49993 9.84889 1.25457 2.04897 +2105 4 47.3911 17.9594 7.65971 14.7535 -7.6497 -21.4463 +2106 6 10.8592 13.9727 9.37152 -3.14543 -2.30259 -2.26695 +2107 4 10.3309 14.6626 8.91794 11.6563 -8.1882 2.6931 +2108 4 11.7607 13.9013 8.99546 -12.5287 13.781 2.06755 +2109 6 34.3902 5.43491 14.0826 12.6346 -17.837 -1.14204 +2110 4 35.1666 5.80709 13.6695 9.45544 21.1547 -1.41353 +2111 4 34.3397 4.58795 13.6148 -10.7305 -5.41844 9.88093 +2112 6 0.19016 0.223418 22.9526 3.77382 -24.7853 -3.01602 +2113 4 0.21308 41.6498 22.1069 2.59646 7.80057 12.2766 +2114 4 54.882 1.08863 22.7473 -12.4607 27.7599 -7.08256 +2115 6 40.9349 30.5562 37.8906 -27.573 -19.5948 34.9696 +2116 4 40.0494 30.8463 38.2359 23.4276 0.414778 -20.0189 +2117 4 41.1198 29.7844 38.4793 13.2677 19.1991 -19.1849 +2118 6 16.6358 17.3088 12.6818 26.7235 26.3695 -9.20965 +2119 4 16.2617 16.4703 12.4231 -8.92935 -8.7699 -0.695474 +2120 4 17.0088 17.6771 11.8494 -7.35458 -7.68048 15.4997 +2121 6 29.681 5.43286 24.7605 9.99716 1.48249 -7.0405 +2122 4 30.3348 5.91815 24.2382 -0.696307 0.629534 -2.6419 +2123 4 30.0075 5.55596 25.6632 -4.07672 -1.78023 1.29455 +2124 6 49.8902 0.287541 27.2058 21.9743 -13.7053 4.20571 +2125 4 49.8511 0.519591 26.2742 -5.37584 5.48457 -4.26768 +2126 4 50.7946 41.8257 27.2858 -12.157 4.98657 1.57708 +2127 6 31.2412 31.7366 15.2127 13.4193 29.9729 -4.01619 +2128 4 31.644 30.8863 15.3566 3.05611 -13.2507 6.82249 +2129 4 31.9953 32.37 15.1128 -22.0385 -12.9049 3.52444 +2130 6 35.7903 24.1511 16.9464 13.6459 1.10276 -6.74723 +2131 4 35.6731 24.9832 16.4455 1.01595 -13.8109 1.97492 +2132 4 36.7089 23.8312 16.7527 -22.9866 2.97508 8.81266 +2133 6 24.2751 4.63968 36.7374 -16.5997 -22.3051 -33.4925 +2134 4 24.7608 5.22686 37.2962 14.6544 10.0168 10.4919 +2135 4 24.7016 4.68474 35.8573 -7.94113 -0.389021 16.9181 +2136 6 17.5636 12.9031 3.65869 27.6744 1.86844 -28.0383 +2137 4 17.6858 13.5605 2.94059 1.9993 -16.4932 11.4828 +2138 4 16.8984 13.3068 4.18363 -27.8054 1.98581 18.3397 +2139 6 4.17446 14.2934 18.2709 12.2351 -24.5699 -15.5283 +2140 4 4.25201 13.3082 18.1842 -5.45348 23.7329 4.34334 +2141 4 3.28482 14.5076 18.5604 -13.4286 -3.54266 5.37394 +2142 6 19.1793 36.8557 22.3908 -6.26797 4.12828 -2.16449 +2143 4 18.7803 36.3059 23.064 -4.74301 -7.71326 18.3965 +2144 4 19.5341 36.2254 21.7686 7.87239 -11.0625 -9.31555 +2145 6 15.659 11.9578 13.1999 9.98626 24.0921 3.91449 +2146 4 15.6233 12.8387 12.7526 3.08695 -23.3335 12.0049 +2147 4 16.532 11.8904 13.6603 -13.5492 -1.68197 -15.0215 +2148 6 24.7583 21.9129 5.36621 -52.0449 4.43235 28.4012 +2149 4 24.9756 21.6947 6.28233 10.5491 3.37037 -1.58044 +2150 4 23.7611 21.9216 5.43181 35.5612 -5.35731 -13.8865 +2151 6 52.741 18.5708 35.2268 19.1809 2.02674 5.12186 +2152 4 52.5591 18.101 34.4104 -23.468 -7.47943 -3.72799 +2153 4 51.9957 18.6447 35.8177 -20.5936 -5.49273 0.0575333 +2154 6 3.56038 27.2788 25.2921 -16.6903 -17.6792 -11.4043 +2155 4 3.96469 27.2185 26.149 7.10467 -3.13705 18.347 +2156 4 3.97939 27.9962 24.8424 10.8751 21.6711 -8.62461 +2157 6 34.4448 32.9974 30.68 48.2331 9.00339 -1.41906 +2158 4 33.5189 32.8245 30.8394 -9.09046 9.48004 8.12592 +2159 4 34.8804 33.6211 31.3233 -29.3839 -17.782 -5.29467 +2160 6 35.2611 23.7526 9.83248 5.28039 9.63542 14.9856 +2161 4 34.4624 23.9143 9.32096 3.45609 1.41047 -6.97204 +2162 4 35.624 22.9154 9.5528 3.26088 -11.8232 -8.34585 +2163 6 42.4243 15.7233 8.97763 12.8326 1.39623 12.6931 +2164 4 41.658 15.328 8.60072 -22.8346 -8.994 -22.1277 +2165 4 42.104 15.9534 9.85586 1.77226 3.68974 5.84069 +2166 6 7.76866 28.8533 32.9548 -11.0049 17.2013 -15.4709 +2167 4 8.04862 28.1203 33.4848 1.42969 -15.0059 16.0601 +2168 4 8.50079 29.0495 32.3677 8.58058 4.20069 -3.59376 +2169 6 17.6953 41.2515 36.4663 -11.3067 -18.3758 74.5383 +2170 4 16.8889 41.7296 36.6796 -1.19906 6.43806 -6.60961 +2171 4 17.8689 41.3412 35.574 12.2332 11.1792 -57.8962 +2172 6 28.5157 24.2416 15.5518 -29.4686 -13.3801 -11.1317 +2173 4 29.0166 24.9984 15.2559 10.2779 3.66755 -9.57255 +2174 4 28.1226 23.7858 14.7645 18.214 7.11075 11.8426 +2175 6 20.955 16.2999 1.15679 52.4547 14.172 -5.31351 +2176 4 20.9215 15.3848 1.33551 1.21723 -32.5558 11.4722 +2177 4 20.0795 16.5686 1.08505 -57.8144 13.7968 -3.85053 +2178 6 31.1684 40.7359 5.3086 9.60886 -48.7905 -14.3252 +2179 4 30.3201 40.4364 4.96776 -1.1434 5.1051 1.34806 +2180 4 31.1111 41.6485 5.46945 -11.8258 44.905 11.395 +2181 6 29.926 24.7744 36.4585 -3.76808 18.8348 4.26027 +2182 4 30.4252 25.4661 35.9713 -7.21832 -13.6313 5.02454 +2183 4 29.9738 23.9763 35.9568 8.68635 -20.1437 -13.5665 +2184 6 8.66863 31.0429 3.90108 5.49181 -25.3701 -11.391 +2185 4 7.74616 30.7992 3.95988 -7.56137 -0.630176 -1.16432 +2186 4 8.75287 31.8877 4.30735 2.25384 31.6916 10.4967 +2187 6 5.52708 32.7014 11.4113 -17.1068 -29.6258 4.38787 +2188 4 4.72561 33.1583 11.715 12.8879 6.23598 -5.09299 +2189 4 5.16474 31.7796 11.3163 19.6841 23.1791 1.24929 +2190 6 45.6525 35.4522 20.4433 4.50188 -15.2767 -13.8779 +2191 4 45.1533 35.403 19.6071 0.884587 3.9764 11.125 +2192 4 46.1815 34.6145 20.4501 -8.61117 18.3435 2.22997 +2193 6 19.5135 2.78077 9.78076 -23.679 -24.2198 -16.6656 +2194 4 19.3296 3.70289 9.60293 -7.62346 7.89228 3.64078 +2195 4 18.7563 2.26696 9.35595 24.4568 20.2801 14.4664 +2196 6 54.9521 9.08257 10.915 1.41457 -13.8994 3.08946 +2197 4 54.8451 8.89609 11.8656 1.69601 3.75098 -5.72792 +2198 4 0.659909 9.73404 10.7859 1.63405 2.05096 5.26063 +2199 6 21.028 26.5613 14.7909 22.3934 -16.1712 -61.6784 +2200 4 21.2545 26.1082 13.8887 -5.63248 33.4215 43.8962 +2201 4 20.0757 26.5096 14.8457 -4.66041 -4.09977 8.40724 +2202 6 14.1565 30.5187 27.5481 43.0568 3.88252 13.2649 +2203 4 14.5478 30.2647 28.4319 -11.7888 3.54471 -30.6513 +2204 4 14.9443 30.8429 27.0102 -33.9181 -6.53128 14.6047 +2205 6 29.8147 17.3367 31.0866 -27.8518 -4.92818 12.2149 +2206 4 30.6554 17.4646 30.6741 20.9401 8.7355 -10.9161 +2207 4 29.248 18.1063 30.9142 12.1966 -0.59561 3.44929 +2208 6 50.8794 17.2985 27.8251 -38.7154 2.44379 -6.74856 +2209 4 49.927 17.6315 27.8951 41.9068 -8.6615 -2.42711 +2210 4 51.4551 17.8493 28.3603 -3.47276 2.02156 5.1771 +2211 6 46.2645 37.0852 13.9854 4.42941 -15.3994 -45.1385 +2212 4 46.1048 37.4162 14.8449 -7.65894 23.339 32.9902 +2213 4 45.682 37.569 13.3645 -0.578519 -6.08013 10.2779 +2214 6 38.1859 37.2676 33.1408 3.52211 -11.0724 24.5555 +2215 4 38.5393 37.4103 34.0404 -6.68303 -10.0954 -6.88307 +2216 4 38.6219 37.9461 32.6369 2.42637 17.4604 -15.0111 +2217 6 41.8357 13.3473 31.1178 -16.0625 23.8584 17.742 +2218 4 41.5851 13.9423 31.8754 7.82637 -22.3228 -20.2899 +2219 4 42.4009 12.6411 31.4368 6.59024 -10.1979 3.85371 +2220 6 46.9027 12.6459 17.8387 -27.1897 30.7666 -32.0186 +2221 4 46.619 13.5972 17.8049 11.7948 -22.8605 3.48595 +2222 4 46.5208 12.2901 16.9886 18.0608 -3.03081 22.7278 +2223 6 32.0582 10.0955 10.6527 -31.4378 50.3229 23.4622 +2224 4 31.7762 9.76632 11.5317 8.81554 -8.40176 -19.9459 +2225 4 31.6698 11.0464 10.7004 29.7372 -48.0302 -12.3835 +2226 6 34.0062 11.3773 6.75186 17.7871 30.589 25.6979 +2227 4 33.4869 10.5999 6.69262 -19.6684 -30.9606 -3.70709 +2228 4 33.8274 11.7035 7.66069 0.227829 -0.558148 -16.2574 +2229 6 45.3288 30.8634 19.4834 2.25993 -0.395596 -7.26595 +2230 4 45.2654 30.706 20.4282 2.85912 -9.1252 8.63447 +2231 4 45.808 30.1003 19.1195 -1.86475 4.39364 7.74954 +2232 6 20.3535 0.575918 7.15275 2.53913 19.7072 2.1264 +2233 4 20.3036 0.62077 8.11765 -6.02971 -5.31178 -3.74759 +2234 4 20.3373 41.5708 6.90351 -3.42232 -20.4047 0.354773 +2235 6 15.9901 39.4523 4.14302 -22.6863 14.3541 -4.96379 +2236 4 15.4898 39.956 3.48033 13.9059 -6.08345 -3.0001 +2237 4 15.6535 39.8695 4.95456 5.06581 -11.7067 3.21286 +2238 6 52.4222 16.4823 25.1021 7.38571 -14.026 0.748627 +2239 4 51.9391 16.8928 25.8315 -3.23714 5.96419 -6.435 +2240 4 52.4547 17.0876 24.3371 -9.72126 -3.91711 12.1205 +2241 6 38.5305 12.9945 3.24722 36.6577 77.8042 9.91619 +2242 4 38.7269 13.7231 3.96388 -16.2716 -45.5952 -32.5571 +2243 4 38.0745 12.2732 3.61889 -23.0516 -27.5087 18.4748 +2244 6 35.1404 29.6968 31.1683 -32.7778 -10.63 75.6098 +2245 4 35.326 30.1595 30.3922 19.5999 28.8984 -42.5223 +2246 4 34.769 30.3505 31.8393 8.36493 -22.8372 -28.4638 +2247 6 9.52941 33.7628 4.86075 -28.4918 10.8311 18.4951 +2248 4 9.24769 34.3211 5.62607 6.24621 -9.23174 -22.6788 +2249 4 10.3628 33.3905 5.10095 17.2263 -8.07265 -0.549435 +2250 6 21.5384 22.0668 20.5377 -8.24916 -13.7408 18.0665 +2251 4 20.8389 22.6833 20.2982 1.69112 5.82217 1.92954 +2252 4 21.3229 21.7148 21.445 5.44386 11.4228 -26.5573 +2253 6 37.5752 11.1922 41.2961 -25.7405 -15.8592 15.4541 +2254 4 38.0284 11.8044 40.7564 10.4246 30.4728 -30.151 +2255 4 38.2644 10.586 41.5433 15.0535 -11.8566 15.4014 +2256 6 33.8981 1.42806 38.7459 -9.94409 -6.93964 -8.18458 +2257 4 33.592 0.608166 38.3248 2.39341 2.703 9.2739 +2258 4 33.9534 1.28552 39.7002 -3.4763 3.29487 -4.45631 +2259 6 4.57081 26.6822 28.0049 6.08842 -57.033 -35.5124 +2260 4 5.0914 25.8197 28.0746 -15.9746 40.4578 4.78317 +2261 4 4.85783 27.3427 28.6052 16.6445 16.915 24.1865 +2262 6 10.2586 0.903759 11.6235 -14.777 -30.5961 35.2813 +2263 4 10.598 1.12099 12.5147 -1.53351 -1.03605 -18.7158 +2264 4 10.5217 1.55247 11.0069 12.731 34.1315 -22.4253 +2265 6 17.6428 19.8087 2.34625 28.3489 11.7442 10.4095 +2266 4 17.8694 20.4455 1.65312 -0.920106 -2.92675 2.15413 +2267 4 18.5186 19.4679 2.66241 -18.7748 -2.39069 -7.57655 +2268 6 32.4269 25.6656 16.4745 -22.7384 46.4686 12.005 +2269 4 32.9526 26.0936 17.1754 -0.693509 -13.2017 -11.5041 +2270 4 32.8268 24.9018 16.1119 18.5502 -33.1172 -3.66835 +2271 6 33.2526 10.6326 0.323883 9.44704 -29.8166 -9.67306 +2272 4 32.8511 9.97264 41.5994 12.5609 21.6724 15.7642 +2273 4 34.1113 10.2426 0.662313 -26.6835 12.0422 -7.05376 +2274 6 4.94395 4.51414 10.1428 13.8645 5.4827 29.102 +2275 4 4.09398 4.95549 10.181 -4.94694 -3.34603 -2.54834 +2276 4 5.29018 4.56097 11.0773 -8.61071 -3.77852 -28.7481 +2277 6 27.0981 16.9726 9.55361 -31.982 10.5528 -14.2027 +2278 4 27.1645 17.5497 10.32 4.78099 0.707575 6.97209 +2279 4 26.2221 17.2303 9.15822 25.9284 -7.90001 11.4222 +2280 6 9.97547 10.5192 19.3751 2.18725 8.20489 55.882 +2281 4 10.4385 9.92127 18.8097 14.3325 -20.7925 -15.5795 +2282 4 10.1136 10.195 20.3283 -2.00877 10.2565 -41.5362 +2283 6 19.5726 8.5313 27.8509 32.1681 -5.32712 19.6321 +2284 4 20.0623 8.73326 28.6965 -13.9453 -3.32017 -28.6613 +2285 4 20.1531 7.88958 27.3718 -16.7413 15.1406 10.2365 +2286 6 47.0715 38.9553 23.1297 -19.9487 1.16408 5.20576 +2287 4 47.6755 38.9992 22.3956 6.55525 -5.77104 -8.99339 +2288 4 46.1921 38.7934 22.7438 5.29072 4.97192 1.21114 +2289 6 19.6864 25.3648 11.2698 -35.9279 -4.62509 3.50742 +2290 4 18.9891 24.6498 11.3772 26.0807 25.4649 -7.71219 +2291 4 19.2193 26.1995 11.535 7.74761 -20.7647 -6.77192 +2292 6 27.3916 13.4622 15.7395 34.9583 -25.2468 -27.4167 +2293 4 26.6227 13.8144 16.1317 -23.8298 14.7279 29.1585 +2294 4 28.0863 13.1847 16.3728 -7.05347 8.15442 -0.924368 +2295 6 18.6718 14.1326 1.43279 -0.407031 -28.5308 -28.57 +2296 4 18.3771 15.0354 1.29678 -0.169849 11.7565 -8.38297 +2297 4 19.1904 13.8513 0.615983 -22.2167 19.1803 27.2908 +2298 6 42.3082 22.0346 32.4819 -45.1257 5.10199 -13.868 +2299 4 42.1064 21.5657 33.301 1.02444 -1.81924 7.74271 +2300 4 41.4227 22.4584 32.2639 35.231 -14.359 4.36271 +2301 6 10.0299 9.44853 2.50633 35.8335 -20.1603 -5.5533 +2302 4 9.22808 9.80314 2.87263 -22.9312 8.40439 12.9687 +2303 4 10.3707 8.71125 3.07205 -18.436 14.324 -8.13067 +2304 6 6.82989 1.45163 22.0085 -48.1074 -31.7833 -34.6048 +2305 4 5.93364 1.52189 21.5813 27.761 13.2569 19.2226 +2306 4 6.99793 0.508973 21.801 12.0554 14.7409 9.93393 +2307 6 11.2802 27.0298 18.9733 1.62982 48.8223 -5.8971 +2308 4 11.8533 27.1031 19.7597 -5.53045 -6.49976 -4.21856 +2309 4 11.2066 27.9871 18.6476 2.337 -33.8373 14.078 +2310 6 41.4807 20.5084 27.2133 -10.1157 30.3313 5.28758 +2311 4 41.6238 21.1535 27.9303 0.1153 -0.646751 -15.7402 +2312 4 41.3475 19.7242 27.7174 2.20222 -28.2193 4.24429 +2313 6 15.4457 24.115 33.4309 -8.0908 -15.9975 4.96928 +2314 4 14.6694 24.1264 34.0087 5.2648 16.329 -3.20307 +2315 4 15.6051 23.1634 33.3621 10.6851 2.75783 3.25666 +2316 6 36.1374 16.3773 10.0083 -2.95201 1.72364 21.0093 +2317 4 36.0354 15.4723 9.6971 0.275369 -1.57281 -6.84486 +2318 4 36.1532 16.3058 10.9756 2.3103 1.89663 -9.38056 +2319 6 51.7249 16.2592 2.09899 -0.8354 -35.479 4.00209 +2320 4 51.3025 16.6477 2.84061 -15.4293 29.383 24.1936 +2321 4 51.7588 15.3279 2.40044 5.70816 13.7616 -13.313 +2322 6 23.409 8.55726 39.7719 39.5062 -11.15 -25.6965 +2323 4 23.7264 8.82822 38.8637 -18.295 -2.70527 32.3134 +2324 4 24.154 8.00621 40.1033 -17.8621 14.2471 -2.43096 +2325 6 36.7611 34.4487 21.1056 -9.59584 -7.71653 -9.58874 +2326 4 37.1943 34.5847 20.2534 -2.45984 1.11901 0.357954 +2327 4 35.8017 34.351 20.9183 13.0848 5.20904 4.89404 +2328 6 14.146 8.88688 27.2949 11.3522 43.6232 -16.453 +2329 4 13.5534 8.17113 27.3093 -27.716 -37.4722 8.68734 +2330 4 15.0033 8.5993 27.5988 11.0136 -4.6565 4.44913 +2331 6 20.6652 37.4903 25.1946 -10.211 -17.9881 -36.0994 +2332 4 20.7454 36.6557 24.6643 4.11278 14.2078 23.4923 +2333 4 20.5382 38.1243 24.4693 3.50396 4.35638 18.4557 +2334 6 28.825 24.4792 30.0383 -7.87557 -12.5525 -14.3175 +2335 4 28.2203 24.3409 29.2957 -5.62902 14.2643 8.72595 +2336 4 29.6177 24.0933 29.6588 14.1928 -3.34691 9.72359 +2337 6 8.38024 12.0023 23.6849 17.6034 -17.8042 43.8798 +2338 4 9.33151 12.0391 24.0095 -25.5352 0.9508 -22.7134 +2339 4 7.93543 11.4413 24.3789 8.15752 13.9726 -18.9857 +2340 6 16.0957 26.6613 22.9482 -4.23776 -4.88874 3.00129 +2341 4 16.4041 25.8866 22.4682 2.11349 3.20317 -0.347462 +2342 4 15.2797 26.4088 23.4009 6.04671 4.79823 1.078 +2343 6 22.346 41.3881 9.48723 24.9275 -16.664 -2.62618 +2344 4 22.5706 0.299269 9.06271 5.87112 18.1013 -4.15908 +2345 4 21.5005 41.5154 9.87839 -30.5435 3.49176 4.55444 +2346 6 49.3776 19.1851 32.3736 41.1751 -38.6142 12.6649 +2347 4 49.9515 18.5305 32.8666 -19.8114 22.1793 -24.5398 +2348 4 48.9751 19.6643 33.0815 -18.7203 16.5505 12.5326 +2349 6 29.672 28.434 31.2292 -0.0990093 -59.7528 33.1636 +2350 4 30.5672 28.114 31.0525 8.33151 24.242 -15.2883 +2351 4 29.4026 27.6233 31.7702 -3.76231 36.9508 -17.5145 +2352 6 5.09757 39.1181 23.5694 28.9365 -16.8561 66.257 +2353 4 5.426 38.785 24.4883 -20.96 9.44698 -53.4069 +2354 4 5.17377 40.064 23.6953 -4.19226 13.7611 -6.16678 +2355 6 42.9396 13.594 41.6013 33.1291 -45.1938 12.1175 +2356 4 42.8466 14.3322 41.0449 -16.6361 37.6348 -21.2948 +2357 4 42.1546 13.3797 0.17078 -22.3633 5.8076 7.08965 +2358 6 21.2201 12.4318 7.37385 41.5974 -14.6934 -10.3279 +2359 4 20.2896 12.3563 7.35505 -36.2241 5.92132 -7.85999 +2360 4 21.5284 11.6004 6.96932 1.7608 11.2928 4.8084 +2361 6 43.1404 26.8989 37.6922 38.0431 -66.5876 34.8581 +2362 4 42.455 26.3454 37.3085 -15.3628 11.0452 -11.3741 +2363 4 43.7284 26.1839 38.1775 -25.099 52.0029 -25.4853 +2364 6 19.5406 10.6485 41.687 -7.00401 -34.9019 -10.1363 +2365 4 19.0738 10.6767 0.596923 -7.19888 -1.38148 21.2635 +2366 4 19.8536 11.5162 41.559 12.2515 43.5875 -9.13673 +2367 6 53.6223 10.061 3.2559 12.5469 7.56169 -12.6981 +2368 4 54.2024 10.8465 3.22155 -5.5124 -7.95383 7.8004 +2369 4 54.0687 9.40413 2.68363 -10.8512 12.6529 5.34221 +2370 6 17.5742 20.1926 28.4231 -27.2496 23.4973 23.4861 +2371 4 18.0413 19.6307 27.8376 17.787 -14.8025 -21.0857 +2372 4 18.1273 20.2938 29.2048 3.54631 -0.489564 0.0042962 +2373 6 36.884 7.32584 1.68504 -56.6071 21.2656 -14.3658 +2374 4 37.7051 7.59774 2.01592 38.2946 9.18211 20.2394 +2375 4 36.4748 8.1931 1.44071 3.42518 -20.8507 2.42249 +2376 6 29.2181 41.4159 1.83346 -7.01124 13.363 14.2223 +2377 4 28.4272 0.01466 2.15652 15.3791 -9.50345 -13.4545 +2378 4 29.1899 41.2946 0.880744 -4.61983 7.49126 -6.31737 +2379 6 13.5157 3.09172 8.12958 -12.3356 7.91728 -16.4605 +2380 4 12.824 3.78046 8.01164 12.4629 -9.10221 7.3254 +2381 4 13.8551 3.1491 9.02604 -1.1531 -1.24526 3.73064 +2382 6 15.0243 29.578 18.5071 -0.689822 5.1468 -1.91807 +2383 4 14.6889 28.924 17.8685 -1.8514 4.35612 11.642 +2384 4 14.2858 30.1508 18.7969 8.46412 -5.78667 -10.3485 +2385 6 10.5031 24.7013 24.3729 39.9308 52.3958 -21.489 +2386 4 10.8696 24.6855 23.439 -22.6214 -1.85919 30.3756 +2387 4 10.1444 23.8694 24.566 -23.1097 -44.7323 0.689524 +2388 6 2.33043 13.8499 25.1512 12.2217 -8.49201 10.1592 +2389 4 1.51988 13.5482 24.7402 -5.80441 -9.83551 -11.7005 +2390 4 2.2572 14.7938 25.1495 -10.3249 16.8303 -2.61333 +2391 6 31.8608 32.7615 29.8175 -5.917 1.92483 -13.0568 +2392 4 30.9148 32.9142 29.9093 1.86919 3.45723 4.06263 +2393 4 31.9038 31.8703 29.4643 1.33296 -6.10517 -4.90202 +2394 6 37.5413 40.8309 33.9785 -53.8639 -49.1526 -10.38 +2395 4 37.2515 40.0243 34.5353 23.0474 40.5808 -8.35317 +2396 4 36.818 40.8104 33.2846 24.4839 11.2763 19.2644 +2397 6 24.0486 38.1463 34.3459 4.38709 -25.8386 -29.9356 +2398 4 24.1932 38.0251 35.2675 1.20986 12.6476 31.9448 +2399 4 24.4562 37.3431 33.9843 -4.45208 9.66559 -5.62065 +2400 6 37.1813 22.5726 7.37313 12.7367 -26.0408 21.8779 +2401 4 37.6868 21.7363 7.50199 -14.9443 17.386 1.08188 +2402 4 37.2974 22.7741 6.46124 2.1827 3.60906 -24.8808 +2403 6 4.31908 23.2435 35.594 -25.7168 -2.52913 6.61784 +2404 4 4.31865 22.3787 35.1609 -1.33991 4.89576 -0.266123 +2405 4 3.37757 23.4898 35.7698 13.7393 -2.9658 -3.46645 +2406 6 15.7444 14.893 2.66063 14.3192 36.2435 46.5189 +2407 4 15.9445 15.8567 2.71494 4.00237 -25.0016 7.78932 +2408 4 15.3014 14.8369 1.84861 -12.1852 -13.1154 -36.1328 +2409 6 48.1607 23.1823 2.03014 17.998 -4.54201 -11.9107 +2410 4 48.5744 23.458 2.84259 8.43731 2.94545 12.5813 +2411 4 48.9225 22.9045 1.46682 -22.9697 5.41467 1.46601 +2412 6 24.1212 19.9771 21.5555 -13.5297 -6.85262 15.9953 +2413 4 24.2241 19.3198 22.2577 -12.7792 13.8262 1.69378 +2414 4 24.7627 19.6352 20.9706 23.452 2.79195 -33.2435 +2415 6 10.5793 29.3754 5.15175 -1.75103 26.9922 -14.4666 +2416 4 9.93004 29.8841 4.64694 -13.9608 -12.0643 5.47156 +2417 4 11.3599 29.8389 4.86113 16.4531 -5.21099 6.28998 +2418 6 5.96767 27.6933 31.2336 10.2296 -18.0279 -26.5205 +2419 4 6.63185 27.1353 30.7398 -17.0624 11.0978 13.8341 +2420 4 6.49058 28.2721 31.7915 6.44996 0.578865 12.7715 +2421 6 18.5397 25.8071 15.3312 30.8629 -17.2743 -78.9847 +2422 4 18.3277 25.7099 16.2038 -28.7942 6.39581 79.7195 +2423 4 17.897 26.3418 14.8644 -17.4943 11.9017 11.8989 +2424 6 52.0949 37.2335 11.1138 -0.736115 -25.1617 0.200807 +2425 4 52.5552 36.4743 10.7101 2.49656 11.0988 9.7325 +2426 4 52.7586 37.8745 11.3958 -2.29245 7.10647 -7.85035 +2427 6 46.8562 14.6296 7.3094 -39.0502 -6.9365 63.794 +2428 4 46.1382 15.0906 7.8718 34.2719 -4.68193 -40.7336 +2429 4 47.0431 13.9061 7.9424 14.2062 7.46383 -20.3992 +2430 6 22.2508 0.698906 41.6783 16.129 -5.34947 -25.8041 +2431 4 22.2008 1.66415 41.7125 4.72421 -6.65403 -6.59212 +2432 4 22.9559 0.389699 41.0229 -20.0941 20.4891 31.5318 +2433 6 4.05761 14.7345 9.27152 -10.7438 13.6286 -6.0443 +2434 4 3.56043 15.5915 9.15395 12.8436 -23.8424 -1.56379 +2435 4 4.93811 14.8828 8.92118 3.87558 5.66633 -1.10852 +2436 6 37.2917 12.6666 37.0157 -30.741 -16.0859 47.3668 +2437 4 37.7371 12.676 37.8973 0.89189 9.6387 -16.8975 +2438 4 36.3707 12.3712 37.2872 32.4569 8.65188 -22.8431 +2439 6 26.6682 29.0903 40.5985 -18.9168 16.4285 3.4146 +2440 4 27.032 28.2632 40.812 19.8197 -36.7417 16.2821 +2441 4 26.6469 29.0593 39.6552 2.37875 14.8387 -20.8034 +2442 6 7.22455 13.851 3.31845 32.6668 -55.3021 -17.7697 +2443 4 8.0198 14.2759 3.60088 8.05656 35.1068 9.02454 +2444 4 7.66854 12.9807 3.04146 -45.3946 28.1811 11.8363 +2445 6 8.95271 34.8627 28.8342 33.802 -52.1542 -15.9648 +2446 4 9.89817 35.0055 28.6074 -18.5208 0.484683 7.95646 +2447 4 8.56267 35.6958 28.9173 -17.8026 46.8286 13.0667 +2448 6 37.1756 40.0691 40.1061 46.0034 7.56439 6.60252 +2449 4 36.245 40.1688 40.0074 -20.2243 -4.13511 -1.70673 +2450 4 37.2907 39.5142 40.8911 -6.64471 -1.97244 -3.69085 +2451 6 30.3689 6.165 27.2364 16.9392 12.8422 63.3115 +2452 4 30.1126 5.75506 28.1249 0.00544273 9.78172 -37.0876 +2453 4 31.0397 6.83064 27.5702 -18.6179 -11.6186 -23.6342 +2454 6 10.4791 22.885 18.2972 2.22892 -25.7937 -34.5052 +2455 4 11.3494 23.0331 18.653 10.7715 4.73748 7.10061 +2456 4 10.6446 22.3032 17.5049 -10.188 21.0769 23.5682 +2457 6 35.8886 14.2524 40.1239 38.6938 29.9036 -1.43051 +2458 4 35.4161 14.6576 39.3846 -1.71718 -13.5804 13.4977 +2459 4 35.4021 13.6019 40.5864 -31.0402 -18.1501 6.5583 +2460 6 6.71723 1.08854 17.7001 -3.83901 -60.8198 25.71 +2461 4 6.23156 1.19942 18.5167 -3.21909 18.7445 0.671973 +2462 4 6.88149 0.099135 17.7878 0.895752 34.2898 -15.7018 +2463 6 41.3468 34.0461 33.1794 10.5682 19.0983 -18.7578 +2464 4 40.4721 34.2712 32.8864 -29.2649 -1.70533 3.43004 +2465 4 41.8357 34.5632 32.5195 11.425 -3.18121 9.05585 +2466 6 37.2595 0.990816 41.287 9.45411 17.3584 -9.40071 +2467 4 37.687 0.20533 40.9743 -1.4253 -22.058 -8.3634 +2468 4 37.4586 1.01742 0.30817 4.28067 1.92511 18.4856 +2469 6 25.2602 30.9527 6.20609 -41.9214 10.7977 -12.9978 +2470 4 25.877 31.4326 5.6764 28.9604 0.775163 -4.96937 +2471 4 24.4759 30.9469 5.60333 12.4846 -9.23957 25.2824 +2472 6 14.2056 24.502 28.3086 -25.5247 14.5131 -24.5719 +2473 4 14.1882 23.6623 28.7056 13.4522 -31.4953 30.087 +2474 4 13.7133 24.2842 27.5041 7.94148 19.2098 -3.82225 +2475 6 34.2051 26.2238 36.0112 -48.9031 41.3361 24.9979 +2476 4 35.1144 26.3624 36.1822 32.7561 -2.50775 4.45543 +2477 4 33.7446 26.9807 36.5344 19.2218 -36.9328 -23.3608 +2478 6 32.3568 8.33098 28 25.7802 40.2385 3.20277 +2479 4 32.7565 9.24505 28.063 -37.9579 -17.4528 3.85033 +2480 4 33.1461 7.94224 27.6538 8.5967 -27.8742 -9.28785 +2481 6 11.7867 0.286536 26.9724 -1.3913 -35.2382 4.72224 +2482 4 11.7865 41.2385 26.6946 0.846362 23.7064 4.93964 +2483 4 11.6054 0.272418 27.9282 2.03777 4.09428 -12.4872 +2484 6 1.68124 0.254113 10.3309 8.7986 -13.2184 -15.0921 +2485 4 1.59717 41.2916 10.7333 -0.0350141 -2.89412 -0.990995 +2486 4 1.41389 0.849687 11.0071 -7.7361 15.4014 20.6266 +2487 6 6.75173 13.8377 8.23874 -3.6693 30.6435 -30.4665 +2488 4 6.43924 13.9799 7.29904 9.51956 -14.6006 30.1073 +2489 4 7.1653 14.6974 8.43116 5.95594 -9.45057 4.81521 +2490 6 22.2348 20.5564 6.16471 -24.0844 -9.72934 13.195 +2491 4 21.6727 21.3518 6.25881 9.87637 -7.56006 0.262552 +2492 4 21.7029 19.8181 6.55593 11.5262 14.9976 -6.6436 +2493 6 17.385 20.4497 10.8769 -35.9329 27.9153 -37.8305 +2494 4 16.5515 20.156 10.4074 25.3596 -4.97581 21.0147 +2495 4 17.441 21.3848 10.5386 11.6957 -25.2138 21.3318 +2496 6 17.7006 4.52737 19.573 -11.3777 -34.9061 -6.08889 +2497 4 17.032 4.43128 20.2569 -5.49224 11.1956 3.68583 +2498 4 17.4813 3.72403 19.0236 15.4315 33.5846 4.92098 +2499 6 0.483339 18.1114 40.0861 11.4726 -7.5634 -25.4826 +2500 4 0.218803 18.6551 40.8031 -6.40406 19.3 17.6992 +2501 4 1.29471 18.4968 39.6981 -7.50073 -9.94226 4.45973 +2502 6 22.9439 24.8131 27.8304 -1.07592 37.7895 -56.3844 +2503 4 22.8309 25.5845 27.1671 -0.125595 -37.7338 24.1587 +2504 4 22.7938 25.2149 28.6606 -3.1997 14.6603 34.334 +2505 6 42.7926 39.1547 26.7662 4.75434 20.2168 6.00074 +2506 4 43.0175 38.5002 26.1242 -2.01943 -24.6309 -11.9253 +2507 4 43.3024 39.9142 26.4608 -1.73796 0.515913 11.2644 +2508 6 26.2338 3.05974 21.8008 -0.713756 21.3652 -6.58596 +2509 4 25.6341 3.75271 22.1513 17.432 -13.3686 -8.49125 +2510 4 26.841 3.50549 21.1637 -15.4189 -7.95734 10.2455 +2511 6 54.5913 9.88629 29.5891 14.6194 -0.200122 15.6168 +2512 4 54.0185 9.11016 29.6389 -2.18077 1.53735 0.0476299 +2513 4 54.8498 10.0557 30.5251 -12.748 -2.88746 -21.9109 +2514 6 24.7662 33.7505 20.5324 -4.4887 -11.5901 7.32024 +2515 4 24.6764 34.6709 20.8407 -1.82029 -5.26135 -2.53883 +2516 4 23.9322 33.4503 20.1388 -0.463927 12.2923 -3.35723 +2517 6 41.7034 16.3049 0.90063 -4.83399 22.4927 -47.1255 +2518 4 41.2734 15.9533 1.64089 -16.394 -13.425 40.883 +2519 4 42.6233 16.3659 1.12415 18.2298 -9.67465 4.77205 +2520 6 23.3998 27.9207 27.4832 -10.7606 37.0497 -28.3533 +2521 4 22.8282 28.3407 28.1441 5.00816 -9.79407 0.156118 +2522 4 23.2556 28.495 26.6632 8.58882 -24.5485 28.392 +2523 6 32.7859 37.2984 18.7364 25.7014 -40.2058 6.96479 +2524 4 33.7401 36.9719 18.7703 -32.5146 22.7172 4.70252 +2525 4 32.7784 38.1932 18.4283 6.4981 19.1078 -10.0488 +2526 6 21.2249 27.6889 4.78917 1.7584 -25.2435 -20.8654 +2527 4 20.596 27.4146 5.46499 -5.42949 1.48454 -4.75098 +2528 4 21.0369 27.1287 3.96943 -0.427807 22.4392 26.4825 +2529 6 54.9457 17.9605 1.83049 24.1732 12.1415 15.992 +2530 4 54.6765 17.1472 1.44643 -11.2843 -21.2768 -12.0273 +2531 4 54.1938 18.5428 1.86671 -18.1074 1.0363 -7.50679 +2532 6 36.7435 10.702 6.59289 -49.1612 2.30359 2.88264 +2533 4 35.7736 10.9925 6.66913 36.3355 -9.83622 -8.29906 +2534 4 36.7226 9.77144 6.87602 6.19961 4.27664 0.325158 +2535 6 54.2959 4.49421 14.021 -47.0247 26.1641 -8.2037 +2536 4 53.712 4.99768 13.3924 28.2438 -8.88077 8.93165 +2537 4 53.834 4.66365 14.8572 10.6634 -9.95324 4.36694 +2538 6 22.1071 12.8195 32.0067 31.7906 8.9597 -11.0311 +2539 4 21.2967 13.3066 31.9589 -27.922 0.108445 -0.906739 +2540 4 22.6887 13.2954 31.3728 -6.4895 -15.5456 16.1837 +2541 6 15.3021 36.6565 4.03444 -21.8215 23.8176 13.2077 +2542 4 15.3262 37.6185 3.88215 -1.10116 -7.72226 9.53853 +2543 4 16.0423 36.3695 3.52653 17.7184 -15.2462 -10.6327 +2544 6 23.951 1.27123 5.71091 12.3119 19.4094 13.4558 +2545 4 23.1735 0.716989 5.76524 -11.3354 -5.61231 -0.786433 +2546 4 24.0519 1.77027 6.55293 -6.00641 -12.6326 -15.7345 +2547 6 14.2792 12.648 15.8066 19.0644 9.13243 11.8341 +2548 4 14.5911 12.5731 14.893 -12.6174 -10.6299 -3.28453 +2549 4 13.3818 12.3002 15.9605 12.2346 2.97194 -15.7557 +2550 6 15.0388 40.2481 6.5891 -30.9219 -16.0267 -20.9978 +2551 4 15.8926 40.3583 6.97574 17.8619 16.6743 19.574 +2552 4 14.4622 41.0349 6.73493 18.0926 -11.8876 3.06612 +2553 6 48.5605 32.6308 12.0872 21.4935 -15.1737 -19.6402 +2554 4 48.2882 31.8163 11.6222 -11.7375 10.5522 8.8403 +2555 4 49.3772 32.8772 11.5869 -20.063 0.749688 13.0696 +2556 6 11.2909 31.5377 7.21713 -14.6129 -9.26005 -15.8818 +2557 4 10.6224 30.9548 6.78826 17.7824 9.96971 10.6082 +2558 4 11.6163 32.1134 6.50388 0.884245 -9.77636 6.63484 +2559 6 30.1231 27.9968 10.2226 9.10006 8.28679 -14.6513 +2560 4 30.718 28.7273 9.95045 -8.34799 -9.59518 10.9295 +2561 4 29.9727 27.4897 9.40845 -5.6962 -0.318113 1.27302 +2562 6 27.6759 22.1164 17.3809 2.93811 -8.1883 -22.8269 +2563 4 27.2909 21.5233 16.7142 1.55949 -2.9899 10.1125 +2564 4 28.0309 22.8242 16.8263 2.77593 4.45495 11.6125 +2565 6 12.9654 4.59514 18.1625 -0.934721 -11.3223 -0.518608 +2566 4 13.4589 3.798 18.4727 -12.2499 12.1104 -13.3514 +2567 4 12.4628 4.36939 17.3497 12.7979 1.84773 4.27522 +2568 6 19.7203 6.71654 19.0744 25.855 21.5282 16.2244 +2569 4 18.977 6.16103 19.2554 -18.9537 -21.446 -0.739234 +2570 4 20.1996 6.78409 19.9214 -9.72031 -0.922856 -11.6068 +2571 6 37.1527 31.3787 11.4669 20.5156 -3.08539 55.9419 +2572 4 36.5467 31.6235 12.1801 -19.4555 -0.126446 -17.2692 +2573 4 37.8531 31.0173 12.0578 -6.7166 -8.42047 -30.0342 +2574 6 3.11862 16.2015 27.3491 -14.8948 -19.7352 -9.46107 +2575 4 2.52427 15.4561 27.6487 20.3886 21.5408 -12.2486 +2576 4 3.15348 16.212 26.3649 -6.24389 -0.0501167 23.7097 +2577 6 15.7133 9.97724 38.3591 30.328 17.4212 13.8857 +2578 4 16.1258 10.8398 38.0549 -11.3336 -30.4403 16.2583 +2579 4 16.257 9.66317 39.1359 -16.0932 10.0631 -23.9552 +2580 6 13.4043 14.2884 8.2363 15.0986 25.1191 -5.83206 +2581 4 13.804 15.2225 8.33958 -5.13839 -47.7054 6.28407 +2582 4 14.0947 13.5837 8.31616 -11.6402 16.8216 1.41307 +2583 6 1.71524 24.3141 36.392 36.4901 -22.2748 31.9402 +2584 4 1.86474 25.1068 36.8985 9.35176 9.25273 5.49175 +2585 4 1.1215 24.6177 35.7571 -36.8309 10.6894 -41.0698 +2586 6 11.1862 26.5319 32.9688 15.239 -24.9993 36.2438 +2587 4 10.9649 26.8002 32.096 -11.5382 16.0703 -24.8314 +2588 4 11.1647 27.266 33.6054 -7.17864 1.89937 -11.754 +2589 6 29.5773 0.765668 36.2911 32.6527 8.9619 33.1448 +2590 4 29.1495 0.596705 35.4758 -23.483 -6.97315 -25.4485 +2591 4 28.9625 1.07408 36.9696 -5.35236 0.153158 -12.2969 +2592 6 43.6099 13.1071 23.908 -7.75428 16.7256 -33.2383 +2593 4 42.8302 13.3868 24.3919 -4.08537 -1.1131 9.93358 +2594 4 43.3622 13.2586 22.9511 7.4693 -9.27191 32.0602 +2595 6 7.44309 19.7767 19.6705 17.8438 12.6527 -6.23579 +2596 4 6.73015 19.1919 19.919 -3.61392 -10.9972 -0.189724 +2597 4 7.6227 19.7194 18.722 -11.1837 -0.704544 3.42764 +2598 6 24.4259 4.29913 7.83629 -8.5248 -0.10499 -3.36953 +2599 4 24.144 5.21077 7.98541 -0.150025 -7.47068 -3.31634 +2600 4 24.9904 4.0546 8.57206 4.90899 -0.271036 -1.18338 +2601 6 51.4883 30.2308 31.1674 -14.7545 1.56633 -0.747328 +2602 4 50.5925 29.8847 31.2768 -1.35209 3.55691 8.49804 +2603 4 51.5844 30.2463 30.2146 11.2248 2.3182 -11.9335 +2604 6 0.913373 23.6795 16.8764 44.9279 -35.4578 23.1065 +2605 4 0.053834 23.3329 16.7065 -24.7033 4.18361 -15.1926 +2606 4 1.39802 22.8443 17.1197 -4.68332 28.5423 -3.90241 +2607 6 45.0884 19.3939 15.6913 9.05154 29.148 -44.7311 +2608 4 45.9115 18.9543 15.4906 10.1171 -6.0821 0.331933 +2609 4 44.8041 18.9926 16.4702 -27.3917 -26.115 43.7395 +2610 6 17.5003 8.70625 40.5861 -20.5343 49.5779 -9.15489 +2611 4 18.1762 9.35755 40.8219 0.532033 0.318295 -4.52849 +2612 4 17.8864 7.89597 40.8225 20.4785 -39.0634 11.6529 +2613 6 30.1832 27.259 27.1983 -17.9859 30.5387 -1.70378 +2614 4 31.0843 27.5469 27.0174 5.19664 -5.65516 3.8328 +2615 4 29.6652 28.1124 27.2385 17.8651 -30.9588 0.0373123 +2616 6 43.0672 26.1987 28.3737 -1.21405 11.7795 -35.2128 +2617 4 43.2187 25.7399 27.5308 2.18298 5.51683 1.33219 +2618 4 43.1307 25.5038 29.0079 -1.74848 -11.3154 21.2466 +2619 6 27.987 7.5851 3.0601 9.13665 18.2748 23.7588 +2620 4 28.1896 6.93215 2.40721 -2.30749 -24.2619 -13.6918 +2621 4 28.5512 7.39371 3.84357 -9.52219 0.418204 -9.11945 +2622 6 44.6779 7.22362 10.1855 -3.82519 12.3682 29.7072 +2623 4 44.5846 7.37997 11.1613 -8.64186 4.71212 -23.3906 +2624 4 45.2067 6.43644 10.1815 9.68596 -14.557 -3.94398 +2625 6 23.537 20.3907 32.2607 -4.33975 0.880185 -5.57314 +2626 4 23.324 21.1985 32.7413 -3.519 5.94106 -1.71472 +2627 4 23.9311 19.8373 32.9365 5.99895 -7.24541 1.02787 +2628 6 37.5412 21.0533 29.2807 6.26587 16.0676 16.0196 +2629 4 37.3761 20.3248 28.6837 -16.0493 -11.7352 -10.5522 +2630 4 36.7218 21.4261 29.6708 7.43039 -8.09007 -9.52559 +2631 6 49.2859 29.0787 28.7031 8.16517 -18.5587 -1.11584 +2632 4 48.658 29.8007 28.598 1.09858 8.52384 -10.5349 +2633 4 50.1522 29.3365 28.3345 -7.12297 8.09394 6.40204 +2634 6 47.5144 18.1684 15.2382 -13.098 45.3115 -50.4885 +2635 4 48.063 17.6794 15.7982 26.613 -22.2712 34.0874 +2636 4 48.011 18.9832 14.9644 -13.0138 -21.3801 10.9042 +2637 6 23.2587 11.168 16.5961 -34.2623 -16.0228 11.9175 +2638 4 23.8181 11.8474 16.2701 22.3391 18.1069 -12.9732 +2639 4 23.6107 10.3074 16.3447 5.63526 2.71733 -4.05723 +2640 6 3.14661 8.32736 23.1966 -5.33081 14.6732 5.33529 +2641 4 3.33443 7.84562 22.3891 5.23826 -4.81966 -4.36628 +2642 4 3.62138 9.17513 23.1245 -2.82501 -4.35917 1.75332 +2643 6 0.508878 16.1819 6.17622 16.4304 7.97407 55.7173 +2644 4 1.47866 16.3831 6.12713 -25.5039 -9.61354 -6.44341 +2645 4 0.329178 16.1408 7.1857 2.48639 -0.0834422 -46.7437 +2646 6 43.1796 15.6993 5.84098 -15.9449 -20.1226 -10.4934 +2647 4 42.9586 16.4507 6.36104 0.864404 19.5468 17.3894 +2648 4 44.0486 15.8407 5.47017 17.9332 8.6581 -2.45416 +2649 6 16.7038 35.4743 34.4518 -23.198 12.4372 32.502 +2650 4 15.9504 35.0582 34.0028 7.47206 -3.63127 2.95791 +2651 4 16.3197 35.7905 35.3305 20.1374 -9.24319 -26.2799 +2652 6 38.8854 7.73874 15.6833 27.6202 35.8952 13.402 +2653 4 39.2486 7.07212 15.1014 0.737034 -8.76325 -8.48971 +2654 4 39.6641 8.33099 15.9666 -32.1226 -27.7665 -11.1551 +2655 6 42.0076 36.5182 13.641 -8.45099 16.164 -4.64077 +2656 4 41.9228 35.5752 13.5656 2.538 -16.9665 4.44933 +2657 4 41.1544 36.8356 13.3036 3.7559 4.14555 2.82714 +2658 6 54.2986 15.3848 32.1119 10.5246 -16.1102 10.831 +2659 4 0.035655 15.9755 32.3754 -8.42237 -3.15332 1.00609 +2660 4 53.5781 15.9253 31.7943 -3.3302 7.96061 -4.64421 +2661 6 22.8954 13.9973 39.0304 35.7671 -1.21675 7.49641 +2662 4 23.2761 14.8055 39.421 -4.93619 -7.73369 -6.00904 +2663 4 21.9819 14.1606 38.8837 -32.0989 6.28079 -4.51925 +2664 6 48.0426 28.53 4.78367 -18.7604 -12.0579 33.007 +2665 4 48.5209 28.7824 4.01456 21.1512 11.8238 -22.7946 +2666 4 47.6247 29.3288 5.14776 5.26678 3.3179 -1.38234 +2667 6 48.833 10.6059 2.66638 -9.19187 -9.9608 -41.9733 +2668 4 48.2371 10.184 3.25557 -19.2293 -15.3999 15.8868 +2669 4 49.4018 11.1117 3.19515 27.1663 25.8201 26.2609 +2670 6 17.1043 29.3494 4.41938 0.116954 -3.05469 4.91749 +2671 4 16.3442 28.823 4.73493 -1.75912 12.177 1.49975 +2672 4 17.4207 29.929 5.14153 -0.429925 -17.6765 -0.899977 +2673 6 27.7901 7.33424 26.577 58.6208 -10.7281 -9.65958 +2674 4 28.6921 6.89516 26.6033 -20.1634 35.8081 4.28732 +2675 4 27.2961 6.54785 26.6418 -36.3357 -24.7905 3.70209 +2676 6 18.0242 22.0537 22.5144 -27.9591 -16.1551 -40.0832 +2677 4 18.4878 21.2118 22.5153 10.7066 -2.42354 6.7168 +2678 4 17.4966 21.98 21.6478 21.0889 16.8172 36.9195 +2679 6 22.144 25.0979 16.6837 -22.767 31.6961 -6.75713 +2680 4 21.8754 25.6012 15.8609 3.46788 -12.1894 37.0641 +2681 4 22.4796 24.2953 16.3382 13.1119 -24.3628 -7.92486 +2682 6 25.5147 28.4379 7.13209 -32.2353 18.5879 42.0502 +2683 4 25.3191 28.6153 8.09624 16.8162 -18.2828 -29.7283 +2684 4 25.4949 29.3399 6.82105 5.5127 9.28731 -21.7507 +2685 6 42.5447 24.7469 23.7482 -26.0567 17.8354 -0.260974 +2686 4 41.659 25.0561 24.0862 27.8337 1.55541 -7.56443 +2687 4 42.5141 23.8045 23.8516 -5.7883 -22.6777 0.706816 +2688 6 6.24511 16.6188 2.47068 -21.6781 9.7655 5.77715 +2689 4 5.36273 16.9874 2.41541 -6.24724 13.8235 -1.18511 +2690 4 6.01398 15.7093 2.58331 16.9883 -26.009 1.35247 +2691 6 47.3719 33.28 1.46148 -3.99946 1.01934 -28.2481 +2692 4 46.9803 34.1218 1.66358 -4.59906 12.9067 -8.65937 +2693 4 47.69 33.0389 2.30921 14.6803 -12.3184 23.7614 +2694 6 1.27616 36.1851 24.8829 8.16993 1.58395 -5.27854 +2695 4 0.639753 36.4584 25.5359 -13.8461 11.829 3.50901 +2696 4 1.57271 35.3754 25.2942 10.46 -9.74103 -2.86729 +2697 6 20.9413 29.0442 16.4303 -37.0385 3.95749 11.2157 +2698 4 21.4069 28.5201 15.8013 19.747 -14.8546 -14.4583 +2699 4 21.4101 29.8248 16.6953 16.4704 9.62387 -0.234111 +2700 6 18.6701 32.5426 14.1399 -11.935 -28.2137 10.094 +2701 4 17.8036 32.9051 14.2078 -15.3524 29.2867 2.90472 +2702 4 18.4356 31.618 14.3552 23.1856 4.50503 -1.59621 +2703 6 15.7338 41.7002 0.007017 -29.1796 -38.8659 -6.04008 +2704 4 15.5134 41.1073 41.1476 16.5192 17.684 16.0218 +2705 4 15.1804 41.3134 0.738607 16.9589 18.7767 -12.0866 +2706 6 20.5358 18.4015 7.20723 -36.4209 10.7746 11.3165 +2707 4 20.1727 18.4996 8.12034 18.5895 1.11111 -8.73102 +2708 4 19.7156 18.4439 6.66948 20.5956 -6.66311 2.45516 +2709 6 35.3359 2.82506 1.61733 -4.03181 47.7257 29.2165 +2710 4 34.9541 3.20961 2.47337 19.1106 -23.159 -34.5889 +2711 4 35.8528 3.61912 1.28524 -9.69035 -30.1723 1.40188 +2712 6 49.0059 19.6751 24.9502 -26.306 10.305 -4.58994 +2713 4 49.8292 19.282 24.7191 18.9727 -16.8119 -2.00329 +2714 4 49.219 20.61 24.9195 -6.54834 1.96917 8.98321 +2715 6 26.0427 7.1974 41.5664 19.1127 -25.9459 -27.3591 +2716 4 26.6886 6.46136 41.6822 -6.92827 19.3426 1.38611 +2717 4 25.5576 7.23966 0.456505 -11.7101 6.8047 33.8929 +2718 6 22.0248 3.60461 29.0185 -16.0846 7.25678 -9.40108 +2719 4 21.194 3.80897 28.5456 14.569 -4.87522 0.502932 +2720 4 22.1959 4.40114 29.525 4.81678 0.210141 7.58007 +2721 6 27.8548 32.5394 20.644 30.2008 -27.0251 30.2495 +2722 4 26.9598 32.7332 20.4747 -36.3343 12.7784 -11.814 +2723 4 28.412 33.1097 20.1287 0.615935 11.6015 -11.5439 +2724 6 8.3956 24.7909 3.45677 41.8783 30.6212 2.1827 +2725 4 8.85983 24.2427 2.83372 10.4085 -11.4169 -11.9204 +2726 4 7.65564 24.3184 3.74512 -41.6031 -24.257 6.19876 +2727 6 30.5856 41.7288 15.6573 18.8319 11.6475 40.5199 +2728 4 29.9513 0.161741 16.3149 8.82373 -8.1621 -4.69308 +2729 4 30.0935 41.6309 14.8822 -24.2072 -8.84927 -42.274 +2730 6 48.0984 5.63232 21.2085 -24.8678 -8.67647 -10.7387 +2731 4 47.6235 6.28714 20.6867 8.63769 7.09972 -0.446275 +2732 4 47.3595 5.05066 21.4474 12.3779 0.983941 9.20385 +2733 6 39.4236 23.163 35.7324 -26.6807 -22.8308 -31.4054 +2734 4 39.8477 23.6904 36.3502 31.9199 30.6139 46.0523 +2735 4 38.8623 22.5516 36.2186 -1.29306 -3.58423 7.04543 +2736 6 51.5883 33.3617 5.78995 -19.5798 -55.0773 -18.3228 +2737 4 51.7861 34.2574 5.89467 9.96767 53.6603 7.25336 +2738 4 51.5145 33.1869 4.82901 1.99858 6.27826 11.2132 +2739 6 40.1205 17.6413 30.7797 3.51386 -32.8888 9.0941 +2740 4 39.6335 18.3955 31.0853 6.47279 10.0891 -2.42254 +2741 4 40.8254 17.9321 30.1952 -5.08805 1.72673 -6.80625 +2742 6 46.4235 9.81086 18.5807 -13.6096 13.2326 25.0066 +2743 4 47.164 10.4099 18.4597 3.17276 -2.49269 -0.272695 +2744 4 46.3941 9.2422 17.832 2.02048 -17.819 -25.0993 +2745 6 15.8844 41.0843 31.9336 24.9021 -3.26155 -16.7898 +2746 4 16.5805 40.7078 31.3592 -9.31569 -10.1627 6.74042 +2747 4 16.1791 0.090931 31.8861 -11.051 9.97246 9.22539 +2748 6 48.5496 25.7276 14.9325 -23.4699 4.48431 -20.1118 +2749 4 49.4421 25.9075 14.7294 36.7388 1.67727 3.80263 +2750 4 48.1707 25.827 14.039 -11.0362 0.596064 15.3478 +2751 6 39.2225 28.9892 36.1575 1.81804 -9.3363 -11.5399 +2752 4 40.0459 29.1043 36.6225 6.32097 13.8964 11.0865 +2753 4 39.5169 28.7877 35.2623 -5.25992 -5.15898 -10.721 +2754 6 37.325 21.0738 14.9394 -7.85324 -20.9229 -64.7065 +2755 4 37.9996 20.7799 14.2865 -1.58038 10.9233 26.036 +2756 4 36.5898 21.2349 14.28 11.1979 5.88457 46.2171 +2757 6 32.4971 22.8607 15.7433 -7.91212 -33.4559 24.7905 +2758 4 31.7632 22.4534 15.25 1.55934 10.0805 -2.32687 +2759 4 32.5592 22.2921 16.5663 4.31702 21.463 -27.4441 +2760 6 18.5773 8.13014 37.5708 2.8796 34.5567 21.0854 +2761 4 19.1021 8.93687 37.8089 1.20854 -19.8484 -10.1251 +2762 4 17.9431 8.09722 38.288 -3.97249 -3.14491 3.87795 +2763 6 46.9308 30.3817 11.0144 7.20248 -9.32119 -46.6603 +2764 4 46.4987 30.7035 10.1833 6.25688 -3.94108 30.979 +2765 4 47.431 29.6318 10.6212 -6.26387 6.19468 23.2459 +2766 6 54.6355 13.051 30.6677 -0.631529 -12.3617 0.377161 +2767 4 54.9401 12.1973 31.0202 -4.70537 6.73717 3.83911 +2768 4 54.6706 13.679 31.4001 -0.542159 7.57402 -2.77471 +2769 6 32.2973 35.1412 27.9506 0.702746 7.41177 51.9011 +2770 4 32.3519 35.6753 28.7977 -4.11304 1.55554 -34.3644 +2771 4 32.0809 34.2722 28.2835 1.42742 -15.3938 2.35714 +2772 6 4.45353 25.396 31.7914 -28.2716 -32.1048 1.32297 +2773 4 5.00928 24.905 32.4172 3.79617 9.45861 3.32159 +2774 4 4.83781 26.2295 31.6234 26.2458 34.1175 0.407684 +2775 6 40.7781 38.1509 21.8521 -13.1408 -33.509 11.5706 +2776 4 40.6716 39.044 22.1698 7.33695 21.0707 -1.24628 +2777 4 41.4481 38.0623 21.1738 10.5508 14.8215 -9.14642 +2778 6 26.6931 9.85845 27.4042 -43.8759 24.145 24.882 +2779 4 26.9952 9.1619 26.8761 23.7363 -35.7414 -23.7206 +2780 4 25.7673 9.60487 27.6152 14.5566 8.07269 5.62533 +2781 6 53.3967 39.4485 11.7649 68.843 -10.0355 -14.0333 +2782 4 54.4148 39.3855 11.5456 -53.2103 8.20916 12.7106 +2783 4 53.105 40.2482 11.2866 -1.29569 -7.05369 14.3337 +2784 6 35.3292 21.4155 2.23587 15.106 -7.83484 -18.4876 +2785 4 34.912 20.5764 2.48744 -1.27765 6.93695 -0.309601 +2786 4 35.8084 21.2289 1.37944 -21.1629 3.53466 26.6292 +2787 6 4.14409 17.1449 33.9131 -16.1644 -22.9901 22.0601 +2788 4 4.14131 16.4411 34.6063 8.69636 10.7601 -14.4963 +2789 4 3.20404 17.192 33.6728 6.06844 1.20479 -9.99864 +2790 6 24.1486 16.1886 14.6752 2.90394 -28.6462 -21.9437 +2791 4 24.2343 17.059 15.0346 0.494679 15.8947 1.83084 +2792 4 23.7735 16.3203 13.7888 -2.47926 -0.947779 4.85435 +2793 6 43.1303 2.83022 26.0988 7.42094 18.4339 -15.1049 +2794 4 42.3152 3.21229 26.4285 -6.54764 -1.84254 4.96768 +2795 4 43.2129 3.23454 25.2082 4.91034 -11.1878 11.8147 +2796 6 40.68 12.1827 1.56051 12.2683 5.96873 16.2718 +2797 4 41.5968 12.2158 1.84207 12.0551 -6.37233 -9.83141 +2798 4 40.2741 12.5174 2.36876 -21.9125 -2.35909 -10.0625 +2799 6 47.3781 8.09655 26.7608 82.0606 26.064 -7.54845 +2800 4 46.666 7.67998 26.3919 -67.6244 -33.3987 -26.4118 +2801 4 48.0445 8.01522 26.0221 -12.6559 5.80771 33.8866 +2802 6 35.8947 30.7223 38.5098 17.2216 52.6179 -38.6143 +2803 4 35.6523 29.9703 39.0072 10.7188 -28.2359 27.6772 +2804 4 36.8587 31.0199 38.5623 -37.3038 -25.1724 3.03639 +2805 6 51.3054 23.2176 32.4969 -40.2617 11.1267 -4.72183 +2806 4 51.571 23.9803 31.9692 8.10126 9.10595 3.65824 +2807 4 52.0738 22.7076 32.6523 27.5758 -14.8312 4.00399 +2808 6 30.6066 4.44965 39.6625 0.615077 -4.04577 -5.4494 +2809 4 30.9728 3.64581 40.0124 3.38991 -22.1323 -0.234101 +2810 4 30.7691 5.02119 40.3987 0.467535 29.3806 6.08815 +2811 6 35.2584 29.6988 2.86074 -18.8762 -20.4699 -30.2285 +2812 4 35.7444 29.7805 2.00551 -3.31399 -2.84145 17.507 +2813 4 34.478 29.0852 2.62897 29.9452 30.586 13.9144 +2814 6 50.3064 26.1399 9.38994 -11.2342 14.6262 -3.47403 +2815 4 49.9288 26.8854 8.86032 11.0364 -25.2497 6.23881 +2816 4 49.6695 25.4035 9.37359 7.94529 9.32604 -3.86417 +2817 6 50.1026 36.8163 26.4125 -14.5138 -5.51826 -11.285 +2818 4 49.5888 36.0167 26.6617 3.79204 13.187 5.56915 +2819 4 50.2319 37.3727 27.1922 -3.20057 1.11223 6.19844 +2820 6 40.3045 23.9511 38.5442 56.3682 27.7758 -3.16545 +2821 4 40.8125 24.7624 38.7991 -6.5383 -29.3065 -12.768 +2822 4 39.4568 24.2221 38.8139 -44.6373 -1.162 12.0349 +2823 6 24.9504 10.7612 30.6561 23.3702 -4.90777 36.4738 +2824 4 25.6234 10.7245 31.4083 -25.7901 9.07318 -40.0098 +2825 4 24.9126 11.6687 30.2959 1.4184 -10.5997 2.42613 +2826 6 5.89627 1.02238 5.41014 -10.9637 -3.10309 -8.95081 +2827 4 5.14436 0.409378 5.47088 11.7326 -0.810065 6.31118 +2828 4 6.70289 0.529043 5.60145 -0.696658 -1.4992 -0.407558 +2829 6 44.282 29.3718 26.2736 69.4655 -24.0165 25.5627 +2830 4 43.5561 29.7046 25.8233 -49.9183 11.7173 -34.3685 +2831 4 44.8903 28.8623 25.6892 -19.9675 5.54095 9.74148 +2832 6 25.3119 10.1784 6.67292 -15.7736 -23.3412 -3.06725 +2833 4 25.6521 11.0537 6.64576 10.6351 24.7362 -4.37451 +2834 4 25.4625 9.79379 5.79618 6.21987 0.326131 1.26241 +2835 6 13.3514 28.0662 2.56722 45.2358 13.6418 17.9819 +2836 4 12.4545 27.8107 2.56105 -32.9681 -11.4511 -11.8173 +2837 4 13.8041 27.7134 1.79344 -6.10921 -0.687749 -0.120894 +2838 6 6.44709 40.2351 18.0254 21.2427 9.30891 -1.39987 +2839 4 6.966 39.4726 17.7533 0.137807 -7.29984 6.20872 +2840 4 5.59682 40.0602 17.6456 -22.1821 0.316247 -4.7234 +2841 6 47.7944 13.5061 2.01255 -17.6425 -30.8617 30.605 +2842 4 48.2016 12.6358 2.19438 -7.04124 7.54818 -3.24284 +2843 4 48.4122 13.9735 1.50015 28.8905 20.8749 -24.4455 +2844 6 13.5944 20.2974 2.4458 20.0315 11.2691 18.6487 +2845 4 13.7883 19.6075 3.10831 1.39134 9.87367 -8.40212 +2846 4 13.0064 19.8713 1.85297 -21.5499 -10.3053 -19.2062 +2847 6 15.2336 0.850818 36.6661 8.37652 40.6516 -23.9146 +2848 4 15.3117 1.46746 37.4264 -6.40063 -24.0213 -7.24367 +2849 4 15.3514 1.51981 35.909 -6.71396 -40.605 26.1829 +2850 6 33.5971 35.2491 15.0847 71.6425 -10.6997 11.4711 +2851 4 33.8969 35.3297 16.0058 -20.0956 -0.49545 -2.4869 +2852 4 34.508 35.0431 14.6807 -47.978 4.31732 -2.67502 +2853 6 21.7981 9.23698 0.429299 24.0185 -25.5324 29.6504 +2854 4 22.426 9.07175 41.6424 8.6426 -4.20457 -11.04 +2855 4 21.1884 9.81045 0.032847 -35.1273 25.1593 -17.3244 +2856 6 38.1453 27.4709 3.0333 47.9463 -55.6761 10.6859 +2857 4 37.7532 27.3037 2.19157 -17.0599 1.14667 -24.2168 +2858 4 37.8405 28.2288 3.44687 -27.291 50.0057 16.1216 +2859 6 38.8714 27.215 11.7709 41.141 -36.7506 -15.3879 +2860 4 38.9285 26.3434 12.2193 -14.3396 10.7389 0.963039 +2861 4 39.5886 27.0941 11.0922 -22.6073 11.6268 16.0227 +2862 6 29.8734 41.5737 28.6987 15.2279 35.2113 -10.5566 +2863 4 28.9552 41.3162 28.7047 -13.1778 -5.77603 2.88395 +2864 4 29.9141 0.263017 27.9132 -0.896253 -12.9147 16.3719 +2865 6 34.03 8.70777 38.0687 38.5763 27.6628 16.1728 +2866 4 34.8607 8.18924 38.1985 -14.88 11.0383 -8.6682 +2867 4 33.3419 8.15213 37.7593 -24.3719 -27.4308 -8.08559 +2868 6 38.8091 27.3495 30.6738 6.32435 -21.1782 -4.52762 +2869 4 38.5154 26.4386 30.4378 -1.34454 21.7952 1.35616 +2870 4 38.3686 27.5808 31.4849 -11.9448 1.82739 7.69603 +2871 6 41.6473 17.269 36.3639 7.45605 15.5752 1.52238 +2872 4 41.3137 17.162 35.483 -10.4634 0.342165 -15.0979 +2873 4 41.7169 16.3923 36.7151 5.72978 -18.5967 8.16978 +2874 6 30.7243 26.977 35.2074 -15.5404 -28.2563 -3.1326 +2875 4 31.3953 27.4345 34.7177 18.5093 15.4635 -5.31058 +2876 4 30.2206 27.5565 35.766 -0.690558 20.2492 9.56945 +2877 6 47.5414 4.09198 27.2867 -2.42911 13.6608 18.2544 +2878 4 46.636 4.37242 27.4325 -10.4037 -2.52064 9.15115 +2879 4 47.5606 3.99786 26.3497 6.55325 -3.96267 -23.0579 +2880 6 20.946 8.39203 7.27322 -27.8597 -45.7319 -0.818331 +2881 4 20.9365 8.74812 8.15774 -0.207227 20.4039 13.5637 +2882 4 21.4094 8.93893 6.67191 21.7448 31.5979 -18.7028 +2883 6 36.8544 13.691 0.855516 -6.96494 -6.58957 -4.7536 +2884 4 37.3845 13.474 1.605 15.5913 2.53244 29.7992 +2885 4 37.0002 12.9032 0.328977 -4.78774 -2.28905 -12.5933 +2886 6 28.5904 20.2994 26.4544 16.2695 -3.42806 -15.5352 +2887 4 28.4835 19.402 26.1318 -1.12761 -3.3858 2.90642 +2888 4 27.7814 20.5406 26.8733 -22.93 6.76513 15.2817 +2889 6 51.6079 16.8571 33.5121 -4.50033 -4.43314 5.93611 +2890 4 51.6159 16.0837 34.101 -3.91985 -0.958274 -7.09147 +2891 4 50.9053 16.6875 32.8669 7.1497 -2.58651 -2.16023 +2892 6 16.2715 32.0073 37.6936 -41.8913 -21.032 -18.7972 +2893 4 16.4093 31.405 38.4555 0.0363557 12.0183 -19.687 +2894 4 15.4977 31.6058 37.1477 38.3353 16.8511 22.6146 +2895 6 14.3407 25.877 13.2155 1.26588 11.3619 -17.2713 +2896 4 13.5013 26.0279 13.6901 5.40221 7.27027 -0.947788 +2897 4 14.4551 26.5608 12.5093 -9.57117 -0.277473 20.5459 +2898 6 54.9749 28.8768 3.30374 1.15612 -53.5629 -1.59986 +2899 4 54.8083 28.9028 2.3467 2.04661 0.129141 5.0455 +2900 4 0.26744 27.9124 3.48546 -12.4506 41.1861 -2.95604 +2901 6 17.22 5.15598 2.57931 -12.7888 -35.846 -9.7104 +2902 4 17.8674 4.52191 2.91459 -1.87097 -9.90488 -4.08214 +2903 4 17.421 5.9071 3.09191 1.36943 25.6696 10.0797 +2904 6 50.6995 33.0507 10.3154 6.59719 15.9916 42.5002 +2905 4 50.6222 33.8517 9.79386 -1.28667 2.08485 -11.8542 +2906 4 50.7575 32.2667 9.79209 -3.80283 -15.7636 -22.9095 +2907 6 28.8826 19.8405 32.3742 18.5732 17.2051 -15.397 +2908 4 29.8373 20.0763 32.2 -31.4986 -11.6613 7.66973 +2909 4 28.4094 20.6578 32.1253 1.55933 -8.77069 7.582 +2910 6 22.4307 12.8248 23.2991 -20.6917 10.5217 33.6658 +2911 4 22.5556 12.3422 24.1574 -2.40655 13.6672 -16.3005 +2912 4 21.7108 13.488 23.4947 18.3613 -16.8762 -11.246 +2913 6 54.7763 15.5394 8.86893 2.10476 3.1215 13.1486 +2914 4 0.465115 15.309 9.51431 10.762 -2.70861 -3.02895 +2915 4 53.9989 15.1653 9.30174 -3.31272 -0.629746 -12.248 +2916 6 10.4518 19.2967 26.1704 43.67 -11.1159 60.7251 +2917 4 11.2502 18.7163 26.2348 -22.5321 13.8961 -6.48776 +2918 4 10.166 19.2541 25.3007 -24.1973 -3.18459 -58.4054 +2919 6 38.6496 20.2998 35.2325 20.2193 -0.813999 -8.63065 +2920 4 39.5955 20.3672 34.9603 -17.6326 -1.16496 9.70871 +2921 4 38.5782 19.6093 35.9099 2.97533 6.68842 -2.65526 +2922 6 17.4906 18.0487 15.2499 -10.3405 45.0299 20.0184 +2923 4 17.3837 17.5615 14.4531 -8.22833 -15.0257 -32.2828 +2924 4 17.2318 18.9864 14.9797 13.5676 -28.3997 10.204 +2925 6 29.6331 0.960567 26.2796 -25.6031 -26.3316 -72.4206 +2926 4 29.3216 1.74647 25.7973 3.40072 6.61544 23.4347 +2927 4 29.2407 0.266373 25.6265 23.6279 16.4272 47.4057 +2928 6 30.4665 12.6849 28.2971 -10.7965 -27.9245 1.17671 +2929 4 29.8272 13.0822 27.7097 -1.40549 16.7134 -9.61387 +2930 4 30.1324 11.7665 28.3519 9.60572 9.94425 5.65357 +2931 6 36.6695 22.1225 33.3577 39.6017 -11.6369 -25.7224 +2932 4 37.5338 21.6663 33.4931 -10.4393 24.3252 -8.31461 +2933 4 36.1732 21.6976 34.0074 -34.1256 -9.27026 38.9845 +2934 6 34.8672 22.4666 14.3113 -12.0535 -16.0605 -66.2467 +2935 4 34.0349 22.4515 14.7407 -19.1997 11.5289 38.0952 +2936 4 34.5417 22.174 13.4128 25.6484 2.69091 24.3313 +2937 6 15.5262 9.60919 7.44527 49.3682 -27.3699 -19.0187 +2938 4 16.547 9.52246 7.26069 -54.7763 6.57045 5.33777 +2939 4 15.1277 8.71762 7.26288 7.76902 16.5773 17.8238 +2940 6 21.8158 28.0339 19.8054 -4.91607 2.79332 -16.2053 +2941 4 21.8614 28.4614 20.6522 -2.04715 7.82991 15.4338 +2942 4 20.8734 27.9328 19.6183 -0.9528 -10.4666 6.26348 +2943 6 34.5348 24.4247 2.43569 30.4222 -68.2311 14.7367 +2944 4 34.4753 23.4054 2.32054 1.69344 45.6403 0.121788 +2945 4 35.3397 24.4934 3.03523 -29.9154 15.8849 -16.545 +2946 6 12.599 20.9348 33.4989 -13.8827 -5.0407 19.8786 +2947 4 11.7591 20.6911 33.9854 14.8004 1.51093 -27.4282 +2948 4 12.4712 20.9089 32.5331 -6.4324 -2.96843 13.903 +2949 6 45.7737 31.1538 8.70434 -2.26925 11.3362 1.64289 +2950 4 45.9542 32.0869 8.96415 -8.39554 -11.7705 -15.6468 +2951 4 44.8313 30.9442 8.82297 5.93432 7.3758 2.64979 +2952 6 15.4817 22.5529 30.1787 5.69125 -30.6905 2.54506 +2953 4 16.2669 22.9885 30.4865 5.73919 23.8488 1.47991 +2954 4 15.7828 21.6299 30.2043 -15.5749 7.04719 -4.74998 +2955 6 39.7421 17.1743 38.4094 21.5551 17.0277 -9.47446 +2956 4 39.5031 16.7163 37.59 -3.21419 -6.16335 13.1695 +2957 4 40.5012 17.7258 38.123 -12.3818 -10.233 9.13463 +2958 6 13.9944 24.6739 0.675362 16.6213 17.4065 1.77653 +2959 4 14.3534 24.6315 1.57006 -7.52322 -5.04497 4.60086 +2960 4 14.2363 25.5684 0.403337 7.11699 -3.23043 -4.31609 +2961 6 31.5223 19.5616 3.57151 -53.5885 6.24325 20.3398 +2962 4 30.9852 19.2876 4.35912 8.49606 10.2921 -25.2864 +2963 4 32.3806 19.3906 3.88708 44.0272 -8.41539 -5.41474 +2964 6 36.1052 25.07 19.4414 -58.1964 5.4792 30.944 +2965 4 37.0178 24.9674 19.4291 53.7837 8.57858 1.17104 +2966 4 35.8724 24.6048 18.6565 -11.4284 -6.26335 -25.0938 +2967 6 51.6856 17.6883 14.8068 3.37141 18.4291 36.2611 +2968 4 51.7159 18.5692 15.274 12.631 -26.1695 -13.2311 +2969 4 51.0805 17.8845 14.1157 -15.036 4.32684 -29.7308 +2970 6 37.7054 27.4905 38.1961 21.1085 51.9404 -4.50496 +2971 4 37.7442 26.8536 37.5026 -5.7586 -24.9449 -15.2301 +2972 4 38.1753 28.2651 37.7886 -14.569 -23.1779 14.5181 +2973 6 34.7911 13.8542 30.7834 63.814 8.34946 -38.9004 +2974 4 35.1479 14.6416 31.2053 -8.52888 3.60926 11.6955 +2975 4 33.9958 13.5796 31.1473 -54.5977 -12.3598 32.1143 +2976 6 19.6332 37.3754 39.9698 -24.3625 -2.8653 -8.02349 +2977 4 20.5737 37.5051 40.1221 10.6449 -2.37562 -1.97502 +2978 4 19.476 36.9037 39.1231 9.83703 4.21653 7.37417 +2979 6 40.9393 34.0697 21.4586 2.1394 -11.0927 -27.2527 +2980 4 41.1855 34.0244 22.3739 -0.995015 -5.02364 12.6588 +2981 4 40.8269 33.1391 21.1809 -5.56645 12.5591 1.05516 +2982 6 32.9542 27.2131 26.5676 21.8236 31.3611 42.3808 +2983 4 33.7455 27.7378 26.9411 -38.3522 -19.3744 -9.62352 +2984 4 33.2804 26.8388 25.7801 14.7034 -8.88898 -37.5519 +2985 6 24.4045 18.6625 15.6046 15.6323 5.3487 0.0952382 +2986 4 23.6496 19.2317 15.7207 -14.8084 -1.4602 1.41466 +2987 4 24.5649 18.2576 16.462 -0.219489 -3.50303 9.55317 +2988 6 29.9663 1.63299 9.06934 -19.1782 58.0281 -13.4952 +2989 4 30.0652 0.728361 9.20589 6.15764 -53.3299 8.23098 +2990 4 29.142 1.69178 8.53744 13.8409 -0.846673 8.85197 +2991 6 31.4884 20.0987 7.87879 28.0207 -11.7442 -56.0977 +2992 4 31.929 19.6692 7.07379 -7.62771 20.3934 38.6055 +2993 4 30.8102 19.4535 8.0257 -16.4635 -8.90407 20.6678 +2994 6 35.0404 3.79156 33.2694 -1.07326 -4.91424 22.8916 +2995 4 34.2545 4.23611 32.9039 10.815 -2.65177 -4.17514 +2996 4 34.969 3.91026 34.2418 -2.62674 -1.77539 -18.1187 +2997 6 43.9504 7.96546 12.9857 17.1829 -21.9111 0.113786 +2998 4 43.3325 7.29581 13.3448 8.44862 12.3123 -3.96012 +2999 4 43.4563 8.73573 12.7333 -15.1408 11.4953 0.0339333 +3000 6 44.1156 32.6759 16.9403 5.31814 23.9263 4.94933 +3001 4 44.7028 33.4557 16.8081 -6.11209 -18.3833 -3.28173 +3002 4 44.1603 32.5425 17.8901 -3.26507 -3.06823 6.73624 +3003 6 40.6044 27.171 19.0399 5.35236 -7.54795 -39.8413 +3004 4 39.9756 26.4797 18.7399 3.73803 11.5815 8.49028 +3005 4 41.0398 27.5246 18.2027 -12.4172 -8.32437 32.3474 +3006 6 46.047 23.2024 29.047 17.2683 37.2743 26.3298 +3007 4 46.6657 23.8797 29.4684 -18.5589 -27.346 -17.4569 +3008 4 46.486 22.3548 28.9238 8.34839 -6.65718 2.80441 +3009 6 42.6215 30.6103 18.862 -5.01232 -15.325 -26.4249 +3010 4 43.5272 30.7476 19.0895 18.324 11.0008 12.4889 +3011 4 42.704 29.9429 18.1625 -17.0641 3.12823 2.85026 +3012 6 36.1251 10.8932 23.2678 23.6581 36.1082 4.04534 +3013 4 35.2523 11.2865 23.1129 -2.80799 -1.69562 1.02392 +3014 4 36.6983 11.6913 23.4963 -28.2294 -33.6871 -7.78786 +3015 6 13.7386 31.5223 15.7271 -4.49361 3.73805 -16.8081 +3016 4 14.6779 31.7192 15.7387 3.94655 -1.56597 5.72926 +3017 4 13.381 32.0318 14.979 -1.5565 -4.12563 8.0657 +3018 6 33.1703 41.4275 27.7797 10.5813 -15.702 68.4674 +3019 4 32.9714 0.101499 27.0951 -7.66273 31.9341 -41.1766 +3020 4 33.2579 0.043937 28.6255 4.60937 -17.5422 -27.6682 +3021 6 32.9019 22.9042 31.4856 -22.5274 37.748 -5.90861 +3022 4 32.2895 23.1741 30.7829 6.44322 -22.1433 -13.1277 +3023 4 32.7242 23.6662 32.0583 13.0029 -8.58894 11.8377 +3024 6 27.6559 16.8629 6.38841 0.759442 -6.33883 29.8789 +3025 4 27.8611 17.2083 5.54221 8.69809 17.4791 -25.8043 +3026 4 26.8031 16.4594 6.24591 -13.957 -6.38022 2.63501 +3027 6 47.2651 11.6173 26.0576 8.33461 35.0159 47.6166 +3028 4 47.0912 11.6838 27.0214 -5.10661 -22.4254 -22.6877 +3029 4 47.7461 12.4597 25.9756 -3.10554 -9.06377 -24.8427 +3030 6 27.5595 7.06242 7.64189 36.0057 -29.1625 5.70238 +3031 4 26.7484 7.49683 7.83093 -25.0876 11.7282 17.2448 +3032 4 28.0841 6.86482 8.45622 -15.7481 15.6684 -17.1357 +3033 6 39.8009 9.06823 11.973 -19.1879 4.0297 -12.8881 +3034 4 39.4826 9.27056 11.0665 6.39012 -4.37616 15.6201 +3035 4 38.9894 9.1094 12.5089 2.28999 7.64442 -1.09803 +3036 6 18.1977 33.4656 36.103 -47.2434 1.22325 7.58723 +3037 4 17.6693 33.9565 35.4324 13.0563 -6.22307 9.58411 +3038 4 17.491 33.069 36.7104 31.5801 5.82297 -20.8408 +3039 6 37.1917 26.5507 0.720984 -4.45309 15.6177 5.32368 +3040 4 37.3846 25.6567 0.44907 -1.85313 -8.64798 -1.56679 +3041 4 36.2207 26.6114 0.739208 8.96605 -1.46339 -9.13916 +3042 6 44.1887 19.6251 36.8885 40.0452 -6.58607 -3.19327 +3043 4 45.0262 19.1233 36.6753 -25.2412 9.90919 11.1214 +3044 4 44.4881 20.5478 36.9825 -7.95545 -4.32402 -1.12283 +3045 6 27.7744 6.35339 35.6933 13.1235 -8.00403 1.40836 +3046 4 27.1655 6.97567 35.3121 -8.4989 9.93248 -6.95364 +3047 4 27.2748 5.53908 35.7675 0.865215 -2.72076 5.22838 +3048 6 34.7673 16.4826 20.8897 25.0208 -26.1622 5.09639 +3049 4 35.5801 15.8751 20.9364 -40.3091 28.8833 0.638889 +3050 4 34.1629 16.1653 21.5964 8.34467 8.45669 -12.6288 +3051 6 39.0349 20.9701 40.4369 -35.0548 -83.2732 -20.3586 +3052 4 38.7355 20.0763 40.8679 21.616 52.9309 -20.1646 +3053 4 39.3277 21.5521 41.0958 10.956 28.6509 41.127 +3054 6 10.8075 27.9275 1.66251 45.0798 11.5101 -39.3642 +3055 4 10.1207 27.6506 2.20454 -46.3214 -11.9312 37.0665 +3056 4 10.864 28.8887 1.77269 -0.956148 -2.75571 -0.87801 +3057 6 47.0235 23.1304 13.2457 -34.1648 -14.46 -9.62139 +3058 4 47.6809 23.5773 12.718 7.19949 7.22116 -4.18429 +3059 4 46.2703 22.9258 12.6132 27.3011 3.73645 28.26 +3060 6 34.5862 28.4037 10.6629 -11.4192 -4.75939 1.42695 +3061 4 34.4799 27.7252 11.3319 -5.35328 -3.69815 4.40234 +3062 4 35.5403 28.4214 10.6073 9.29856 11.2923 -14.2157 +3063 6 3.3474 17.5828 14.2796 -19.4871 24.8451 -12.2706 +3064 4 3.54237 16.6973 14.5399 7.15819 -24.2504 13.4427 +3065 4 3.84281 18.1577 14.8755 9.98901 -5.90389 -1.38432 +3066 6 27.7213 11.5993 7.52196 5.39723 39.0715 -5.17771 +3067 4 27.6701 12.604 7.61024 4.43832 -37.6789 -1.1729 +3068 4 27.2296 11.2227 8.25132 -2.72363 -3.1191 8.53492 +3069 6 41.4314 28.3382 9.01837 19.0589 -0.973961 -18.7609 +3070 4 40.8555 28.7961 9.62238 -6.75468 20.1798 6.66135 +3071 4 41.7073 28.957 8.28743 -10.8025 -14.2077 17.7393 +3072 6 42.0854 4.7797 8.18851 -21.257 14.5957 -52.3899 +3073 4 42.0432 5.70949 7.81908 14.9695 -22.9802 20.9203 +3074 4 41.8649 4.22501 7.38905 12.6142 12.8494 32.4876 +3075 6 28.4682 8.6325 40.3242 -61.7219 6.47809 -5.55454 +3076 4 27.7379 8.57122 40.9835 27.869 -4.13123 -2.00049 +3077 4 27.8882 8.69791 39.5144 34.8971 -1.31486 9.68376 +3078 6 0.711352 18.2475 15.2828 -1.03732 14.0577 26.4962 +3079 4 1.6037 18.2498 14.9622 18.0256 -6.96047 -13.9963 +3080 4 0.201613 17.7329 14.6701 -10.6254 -13.4061 -11.9404 +3081 6 7.11345 16.2289 40.4432 8.45023 -35.9074 47.1296 +3082 4 7.17312 15.3057 40.7986 -0.221024 11.0765 -27.8146 +3083 4 7.22051 16.6703 41.3088 -5.23596 22.4775 -22.5048 +3084 6 41.0858 8.62552 20.9048 11.0684 -11.3616 26.0286 +3085 4 40.3918 8.42716 20.2762 -10.0062 9.73992 -12.3328 +3086 4 41.3944 9.53753 20.8124 -4.81268 6.06535 -10.7329 +3087 6 31.7073 7.42286 37.542 -14.8479 -9.90339 6.69006 +3088 4 31.4959 7.12404 36.6506 2.47263 0.526998 -6.01676 +3089 4 30.9335 7.11441 38.0458 14.4773 7.59586 -0.291785 +3090 6 40.7266 11.6476 25.425 -35.4896 13.4329 -16.1803 +3091 4 40.7395 12.5913 25.6925 9.9362 -18.5419 -7.18222 +3092 4 41.5423 11.2236 25.6435 22.7694 -4.71413 12.394 +3093 6 29.8665 30.1579 6.66307 26.6562 -4.16721 8.5177 +3094 4 30.5555 30.7343 6.31583 -2.18777 1.73834 -10.5199 +3095 4 30.3573 29.3259 6.76714 -13.2281 -1.59651 -6.45815 +3096 6 40.8439 24.5837 5.68012 15.8615 33.1962 -4.14396 +3097 4 41.3457 25.4223 5.9023 -8.27611 -29.5734 -8.52614 +3098 4 40.1119 24.5659 6.27901 -12.3156 -1.80355 11.8721 +3099 6 34.3917 9.09675 20.4219 17.6262 -1.15942 17.9162 +3100 4 33.57 9.43601 20.7884 -5.86563 4.88571 -3.34935 +3101 4 34.2167 8.80099 19.5352 -13.2656 -6.03918 -15.2606 +3102 6 18.2311 33.5548 26.5354 9.60899 -55.578 -54.4315 +3103 4 19.159 33.2107 26.4405 -23.3884 24.4218 8.45675 +3104 4 18.1621 34.044 27.3085 3.33799 34.4716 53.9641 +3105 6 28.9072 17.4193 26.7965 8.90265 -1.34032 10.3526 +3106 4 28.3267 16.8801 26.2506 -9.53448 5.67773 -5.57268 +3107 4 28.3756 17.7646 27.5432 9.63981 -8.23286 -8.72686 +3108 6 50.4255 35.5446 18.192 14.112 9.6817 -2.74072 +3109 4 50.5661 35.3326 17.2487 -8.6314 -7.47676 15.7559 +3110 4 50.5766 34.7477 18.7329 -11.9848 3.75846 -10.2286 +3111 6 2.99463 21.5653 31.4474 1.68271 -21.0005 -22.757 +3112 4 3.33698 22.262 30.8385 -11.1525 -11.1618 12.076 +3113 4 2.83901 20.7479 30.8788 5.9339 29.1288 19.4027 +3114 6 36.1811 18.7457 8.60665 26.0746 50.7707 2.54435 +3115 4 36.1969 17.9289 9.04749 -6.79937 -48.2248 12.3681 +3116 4 35.6147 18.7828 7.85483 -18.853 -7.00319 -22.0811 +3117 6 20.2934 6.48366 33.7248 -33.7925 -21.1439 9.08779 +3118 4 19.8228 6.33509 34.5702 11.9648 11.0481 1.53323 +3119 4 19.9109 5.73333 33.234 17.8653 6.32962 -8.93867 +3120 6 14.0016 30.5326 6.65439 -2.06342 0.226434 14.1624 +3121 4 14.6658 31.0189 7.18657 -8.4774 -5.82658 -13.2159 +3122 4 13.1556 30.6664 7.11082 5.19683 1.19435 -6.65694 +3123 6 36.2738 16.4523 35.7634 28.7444 28.7466 -1.25628 +3124 4 37.2529 16.3082 35.8444 -30.8138 -2.80693 3.80535 +3125 4 36.1869 17.4417 35.6433 -1.25715 -33.4762 0.326736 +3126 6 45.8255 37.6646 9.68707 16.0609 -41.2042 -13.6418 +3127 4 45.4852 38.2919 10.2717 -20.4348 34.8513 25.7777 +3128 4 46.231 37.0083 10.2774 7.06244 2.74597 -12.4723 +3129 6 47.4229 17.9968 27.6368 -1.79372 -57.0164 -4.60636 +3130 4 47.566 17.432 26.8065 -4.8869 24.4286 27.8294 +3131 4 47.3631 17.3546 28.4089 6.87022 22.2846 -25.0829 +3132 6 25.9574 18.2976 0.964228 23.0858 -4.77958 -10.3735 +3133 4 26.3734 18.9022 1.60725 -19.9671 -4.02324 -2.33442 +3134 4 24.9961 18.2982 0.948557 -9.32218 6.60301 10.8105 +3135 6 27.3657 22.4026 4.28337 1.04907 -15.9856 -17.2206 +3136 4 27.2658 23.3197 4.47064 2.83879 26.7243 10.1579 +3137 4 27.3462 22.4079 3.3181 -1.05974 -10.8362 7.50108 +3138 6 3.39902 3.84297 27.6033 -32.797 -16.937 8.3321 +3139 4 3.87422 4.64571 27.4715 26.6916 15.5682 -1.1402 +3140 4 3.96055 3.06079 27.6076 7.92228 2.5358 -5.38712 +3141 6 45.3564 27.6573 28.835 13.8657 -6.64535 19.4164 +3142 4 44.592 27.1099 28.6295 -10.1072 2.65107 -0.516215 +3143 4 45.3903 28.3299 28.161 -2.22034 5.33578 -9.67936 +3144 6 28.3928 32.384 16.2149 35.1766 -7.36337 1.61596 +3145 4 29.2284 32.2059 15.7054 -23.0821 5.0916 11.0276 +3146 4 28.7076 32.6186 17.1078 -8.03404 1.42552 -9.59962 +3147 6 9.90485 33.8293 13.0286 10.5996 -3.42126 36.647 +3148 4 9.63365 33.2371 13.7754 2.50037 15.8816 -14.8106 +3149 4 9.32864 33.6931 12.2897 -16.1444 -6.90665 -19.0975 +3150 6 38.3335 26.6343 14.9205 -0.551684 -24.4487 3.86314 +3151 4 38.658 25.7334 15.149 1.53578 20.736 -5.06851 +3152 4 37.3858 26.5974 15.0972 1.00556 4.30146 -0.183996 +3153 6 31.3571 16.3836 4.2445 -16.7299 -18.7641 16.8138 +3154 4 30.5501 15.9079 4.56795 14.9054 8.61271 -6.80276 +3155 4 31.2311 16.4593 3.29715 -1.72501 9.16645 -9.12782 +3156 6 6.17482 3.39637 6.55833 17.6941 29.4886 56.031 +3157 4 6.41103 3.08651 7.49149 -7.06328 10.7723 -41.2395 +3158 4 5.9143 2.63963 6.07247 -2.51266 -29.5732 -15.1374 +3159 6 42.5954 13 5.61529 2.6815 -10.2341 6.00586 +3160 4 42.2228 13.83 5.89445 -1.70762 9.74234 -1.3058 +3161 4 43.4476 12.9425 6.06763 3.18432 -3.38396 -9.63491 +3162 6 41.0469 31.4032 33.8032 -2.41258 31.7421 -2.74763 +3163 4 40.7074 31.3974 34.7214 7.44932 1.1292 -16.4995 +3164 4 41.1575 32.3688 33.5162 -1.31614 -41.8694 16.6901 +3165 6 52.8576 12.0626 26.2641 9.5895 -24.4248 -55.9842 +3166 4 52.4684 12.727 26.7939 -19.7064 26.0739 18.5009 +3167 4 52.6066 12.2568 25.3043 12.3637 -4.77707 33.6793 +3168 6 39.2086 4.29542 29.0724 8.4008 5.1904 -7.5125 +3169 4 38.4444 4.85752 29.2861 11.0986 -5.7068 1.32154 +3170 4 39.9986 4.64958 29.5231 -9.05665 -5.78587 -2.57989 +3171 6 3.65769 27.0104 11.285 -33.2394 -3.70913 -3.8751 +3172 4 4.59992 26.8829 11.3514 17.6792 2.33561 -5.11125 +3173 4 3.4519 27.7953 10.7423 10.2361 0.60791 3.91121 +3174 6 41.5441 29.6402 25.2654 2.79284 -4.6021 22.0238 +3175 4 41.8464 29.7038 24.3667 4.04268 2.71218 -16.2057 +3176 4 40.7127 30.1073 25.3399 -6.11251 5.69311 -9.79107 +3177 6 50.4754 27.4974 30.671 -6.87832 -12.1873 7.27551 +3178 4 50.0778 27.1279 31.4799 3.22248 2.82006 -4.01445 +3179 4 49.7824 27.9982 30.2275 0.0461655 4.73 -3.38362 +3180 6 32.7876 33.6322 41.7537 -8.7541 -8.89692 -39.0089 +3181 4 33.1671 32.7559 41.8028 5.47994 -11.5785 5.15438 +3182 4 32.9083 34.029 0.675063 4.83491 15.974 33.6037 +3183 6 5.9806 9.64323 7.93715 4.3965 6.41539 -15.2951 +3184 4 5.77829 9.93579 8.8312 0.6559 3.73469 4.68299 +3185 4 6.3228 10.4083 7.4265 1.56495 -8.59939 9.02132 +3186 6 52.7884 25.3949 27.7 -7.43266 -9.74322 -1.44878 +3187 4 52.93 26.351 27.8747 -0.851616 -24.8244 8.41831 +3188 4 52.9998 24.8518 28.4994 7.3809 16.2458 -18.9874 +3189 6 18.6796 23.2043 14.4609 8.49541 46.7244 28.1607 +3190 4 18.697 24.1166 14.872 -21.1178 -26.825 -16.729 +3191 4 19.5981 23.1771 14.2416 15.365 -21.3066 -15.3625 +3192 6 31.2857 9.07887 13.0786 26.2489 -54.2202 -11.3888 +3193 4 31.3193 8.20519 13.5416 -2.63874 16.5358 -10.154 +3194 4 30.7972 9.64602 13.6278 -24.9284 29.9413 31.6235 +3195 6 52.8163 16.833 29.9704 25.4684 -2.46115 -18.7711 +3196 4 53.1785 16.3479 29.2052 -11.8989 0.938692 6.7974 +3197 4 53.5445 17.4528 30.1342 -3.36222 3.81908 9.3955 +3198 6 13.4835 30.6533 11.9137 -46.9609 -12.8402 15.0292 +3199 4 12.8701 31.2475 12.4314 22.3442 -12.341 -15.3642 +3200 4 14.3315 31.0589 11.9363 20.4041 22.2607 2.0467 +3201 6 24.4145 24.6647 11.1793 -22.2983 -41.6602 -10.5575 +3202 4 25.2113 25.1208 11.3859 27.2622 9.38308 11.5927 +3203 4 24.6402 23.6908 11.0915 -11.4513 27.6962 10.6476 +3204 6 11.1203 26.798 5.92715 -0.288466 28.8994 -0.991584 +3205 4 11.4516 26.991 6.8143 4.21529 -7.59652 -0.673238 +3206 4 11.0194 27.7223 5.58288 -7.6649 -30.4822 0.0195949 +3207 6 12.0071 32.3096 4.57291 -4.86243 14.2275 -68.6847 +3208 4 11.7793 31.9281 3.63093 8.01684 14.4954 56.5286 +3209 4 12.2995 33.2463 4.37904 -4.11207 -26.5611 6.70158 +3210 6 6.4322 5.49281 30.4716 35.2368 -18.2726 5.22228 +3211 4 6.85856 6.3256 30.2181 -6.14256 4.86399 -3.96588 +3212 4 5.49729 5.53619 30.4137 -26.8093 16.306 -3.74387 +3213 6 38.1866 39.6 29.3849 -55.2477 -18.0227 -31.7741 +3214 4 37.4363 40.1798 29.0864 28.3626 1.3397 12.8196 +3215 4 37.8398 38.7214 29.0428 28.3274 26.4583 13.0641 +3216 6 52.5811 19.3636 5.41604 51.907 48.1011 -36.5249 +3217 4 52.4834 20.3242 5.17263 -20.1975 -32.0404 8.71389 +3218 4 53.4908 19.2453 4.99747 -31.6145 -20.6418 25.5541 +3219 6 18.3356 9.8205 21.0747 -17.6268 -29.6196 -17.636 +3220 4 17.8021 9.40634 20.3533 -1.88913 9.35392 27.897 +3221 4 19.0546 10.1733 20.5835 25.9839 20.5094 -7.72749 +3222 6 14.4924 41.1161 15.0432 10.1364 3.71296 -9.89663 +3223 4 15.2732 41.1462 15.6022 9.62288 -5.62086 4.10329 +3224 4 13.9031 41.7078 15.5102 -8.32301 1.75038 3.32266 +3225 6 35.9996 23.9069 26.7492 18.6837 -25.8156 -39.8793 +3226 4 35.9246 23.4421 27.5469 -8.45021 -0.659318 44.9575 +3227 4 36.3072 23.1381 26.2025 -8.08285 36.2837 5.17172 +3228 6 35.634 10.4286 26.2543 -16.0886 -36.8378 31.8954 +3229 4 36.0318 10.4196 25.4062 11.0324 6.64788 -31.8122 +3230 4 35.4344 9.46932 26.4326 4.10196 23.0818 -6.20158 +3231 6 45.3004 24.2842 20.2749 24.2383 10.4641 7.4623 +3232 4 45.3515 25.0535 19.6808 2.20237 -7.91345 -3.22769 +3233 4 44.5434 23.7522 20.0895 -20.4117 -5.11737 -13.922 +3234 6 15.8182 39.0515 24.2407 12.965 16.6456 0.954929 +3235 4 15.3741 39.8779 24.5544 7.5658 -17.411 -0.0196462 +3236 4 16.7724 39.3066 24.1247 -29.8541 -4.22386 6.92178 +3237 6 4.60659 25.9073 16.8122 1.83212 2.60998 -1.97709 +3238 4 5.31562 26.4095 17.2499 -5.00617 -6.2898 0.278133 +3239 4 3.79975 26.4302 16.9186 11.5163 2.87992 -0.585475 +3240 6 33.4767 9.9887 32.5701 -44.5277 -5.18869 -27.5725 +3241 4 34.322 10.1593 32.8843 54.6618 16.656 18.5178 +3242 4 33.0203 9.70843 33.3575 -8.70161 -12.0001 8.14623 +3243 6 22.9321 37.514 1.50284 -0.19108 -28.0604 17.8877 +3244 4 23.0149 38.2279 2.13297 1.92014 9.99004 7.14626 +3245 4 22.7552 36.7067 2.06858 1.19451 21.8657 -20.5647 +3246 6 39.1248 20.5474 25.4766 21.2332 -16.8391 26.0428 +3247 4 39.2186 21.3943 25.0643 2.22233 17.645 -5.02625 +3248 4 39.853 20.5019 26.1611 -16.83 0.667515 -19.8449 +3249 6 25.0699 25.071 37.6104 17.3941 16.9986 -26.7924 +3250 4 25.9994 25.4036 37.6322 -19.4928 -16.3283 1.07636 +3251 4 24.8822 24.8366 38.5108 -1.54859 -5.98321 18.8059 +3252 6 12.2108 35.7702 11.4211 -21.274 -0.450661 -24.3109 +3253 4 11.4942 36.1177 10.8268 17.2098 -2.57945 23.3101 +3254 4 12.7534 35.3113 10.7723 8.20233 4.40137 5.7707 +3255 6 42.0318 15.7212 20.1319 23.9789 -4.66934 -19.8056 +3256 4 42.573 15.4482 19.3354 -11.2719 11.6022 18.1956 +3257 4 42.3198 16.6222 20.3614 3.24172 -2.08619 -3.65764 +3258 6 53.203 25.4276 39.527 3.00787 -13.9161 6.63788 +3259 4 53.7641 25.8569 38.8977 9.18601 6.10619 -8.92001 +3260 4 52.4886 26.0297 39.6953 -12.4398 9.9207 3.51955 +3261 6 53.7999 21.7704 1.29423 13.4333 -6.07506 22.1965 +3262 4 54.6908 21.5389 0.969279 -9.57261 -3.1085 -1.99035 +3263 4 53.3016 22.2177 0.619486 -6.56312 6.61298 -22.2093 +3264 6 1.93757 22.4543 20.1748 -8.22485 -1.41006 19.3874 +3265 4 1.60089 23.2534 20.6505 8.04613 -19.7643 -7.74833 +3266 4 2.27012 21.8339 20.8623 2.42307 18.0741 -7.93574 +3267 6 41.1802 16.179 11.484 -8.24259 53.7733 14.6683 +3268 4 40.8475 15.3772 11.8508 -2.32532 -30.9762 7.10209 +3269 4 40.6167 16.8825 11.9353 16.6943 -22.3779 -21.294 +3270 6 17.1967 38.6113 9.60334 5.35995 -1.86267 -8.12923 +3271 4 17.7852 38.6361 10.3521 13.641 -0.452934 12.0217 +3272 4 16.3282 38.6029 9.98982 -18.6262 -0.708432 10.1602 +3273 6 33.1969 12.9538 38.5484 12.352 25.5713 -8.86638 +3274 4 33.6486 13.824 38.4674 -8.05485 -18.2555 -5.8969 +3275 4 33.0335 12.8861 39.4897 4.37007 -7.66636 -4.23751 +3276 6 24.7228 21.6957 39.9776 0.331302 -26.4697 -8.75647 +3277 4 24.5832 21.6143 39.0045 0.235774 0.581704 12.5709 +3278 4 25.2663 20.9218 40.2505 -4.0265 10.6546 -4.86064 +3279 6 13.577 15.5497 27.3411 27.7809 44.9786 27.5516 +3280 4 13.196 16.0821 28.0648 5.30872 -0.0493108 -10.0398 +3281 4 12.9031 14.935 27.2057 -29.8548 -39.4113 -11.0219 +3282 6 24.6863 18.7248 9.26482 -8.80414 -2.51529 14.0236 +3283 4 25.3563 19.2311 8.7609 -6.6335 -0.338001 12.1858 +3284 4 24.3761 19.0911 10.1338 17.243 1.91927 -22.7003 +3285 6 10.9743 8.21046 0.042398 -18.7759 13.8117 62.0104 +3286 4 10.3469 8.74796 0.639501 28.6352 -16.9877 -21.8389 +3287 4 11.7753 8.08291 0.592641 -4.28958 7.52309 -10.9298 +3288 6 15.7499 31.9609 31.3743 -17.6212 -20.5964 15.467 +3289 4 14.8817 31.9157 30.9761 -10.6343 5.00824 -7.09118 +3290 4 16.0827 32.8403 31.1978 10.1106 0.369155 -2.88897 +3291 6 20.3726 39.1695 21.6147 20.5981 -29.5513 41.0934 +3292 4 19.9726 38.3531 21.9994 -5.82675 23.323 -22.8284 +3293 4 21.1172 39.24 22.2595 -11.0324 14.4144 -20.0969 +3294 6 38.8594 19.5251 7.6091 -6.47304 13.0289 -25.1371 +3295 4 38.0017 19.0955 7.57416 -1.20877 -0.517864 1.64758 +3296 4 39.1744 19.3685 8.48411 8.18586 -10.9486 17.219 +3297 6 41.3695 29.7301 21.1465 -57.7285 -14.4296 34.1578 +3298 4 41.7832 29.6286 20.3251 24.9116 3.74799 -36.1007 +3299 4 41.9865 29.9579 21.8177 26.2541 9.18996 12.3917 +3300 6 50.7039 33.8333 22.0593 7.50244 -20.9835 17.6314 +3301 4 50.9654 32.9474 22.4123 -1.20949 24.7473 -8.4765 +3302 4 50.362 33.6446 21.1779 1.66119 1.27804 -3.63001 +3303 6 18.1671 11.1714 14.3658 -12.4278 -6.78987 13.7569 +3304 4 18.0724 11.2679 15.338 -0.312443 2.59996 -20.4321 +3305 4 19.115 11.0923 14.227 4.83391 -0.924272 -3.79066 +3306 6 48.5058 14.2689 15.2513 -36.7782 -21.7282 -18.3567 +3307 4 49.3677 14.5693 15.4148 44.1026 10.3807 8.68918 +3308 4 48.5803 13.5893 14.5426 -8.44167 10.5166 12.8885 +3309 6 32.9801 15.74 8.25484 19.5805 1.81858 6.30948 +3310 4 33.8151 15.5666 7.78828 -7.72407 0.576521 2.61047 +3311 4 33.2057 15.7253 9.21147 -5.47651 1.26655 -15.0149 +3312 6 42.9141 4.85593 18.7596 35.6338 16.8786 18.3104 +3313 4 43.0674 5.82698 18.891 -14.0493 -22.2454 -3.89051 +3314 4 43.7794 4.50634 19.0974 -23.5505 0.71427 -17.3058 +3315 6 10.488 23.7131 33.4436 27.6073 45.1219 -14.7699 +3316 4 10.638 24.6985 33.3892 -15.3766 -28.1208 6.63949 +3317 4 11.1638 23.4099 32.8243 -6.46894 -14.1785 5.09081 +3318 6 1.12582 20.0662 11.2775 2.81918 8.09367 56.8435 +3319 4 0.488344 19.3589 11.407 -2.14544 -6.99577 -20.9797 +3320 4 1.17571 20.424 12.22 2.69463 -2.11621 -44.733 +3321 6 1.50824 39.5346 14.3079 -5.25271 -28.0543 15.9462 +3322 4 0.868346 40.1487 14.6984 3.61457 -0.641003 -8.28938 +3323 4 1.2571 38.629 14.6571 12.5115 33.2201 -10.0417 +3324 6 8.3332 21.6069 14.1357 -16.8636 -16.8509 36.8071 +3325 4 8.17334 21.0976 14.9962 5.25323 23.3985 -29.627 +3326 4 7.56323 21.4407 13.5807 -3.95337 3.79773 -2.56685 +3327 6 7.16177 13.3249 38.2255 -6.34169 -18.8056 -1.32195 +3328 4 6.69256 13.0329 37.4043 9.76156 12.0715 20.3406 +3329 4 7.43529 14.2522 38.1581 -0.0118119 -11.8895 -14.491 +3330 6 46.6212 1.64167 18.6867 -0.0463537 -24.1078 41.7639 +3331 4 47.541 1.5611 18.992 -0.862753 9.16913 -10.8716 +3332 4 46.1606 1.36736 19.5239 4.43612 14.9978 -24.7224 +3333 6 4.08147 8.39338 14.788 26.1694 13.8207 2.32184 +3334 4 3.41636 8.28931 15.4347 -29.1417 0.0985708 23.0338 +3335 4 3.90156 7.69349 14.1818 -2.47935 -14.3959 -27.3016 +3336 6 47.5712 36.5372 17.8422 14.6219 44.3363 14.3039 +3337 4 47.1691 35.7037 17.6938 -6.70251 -40.3849 -9.96305 +3338 4 48.5299 36.4434 17.8412 5.708 -14.7801 -1.83759 +3339 6 48.7177 32.6293 3.61477 24.5557 -7.82504 -30.2396 +3340 4 49.3183 32.0587 3.09719 0.221751 18.4164 7.83871 +3341 4 48.4066 32.0299 4.25286 -21.3126 -17.4552 36.5328 +3342 6 26.8672 34.4113 15.184 7.18591 -12.831 -4.85448 +3343 4 27.1806 33.7337 15.7866 -5.2278 -3.11582 5.08403 +3344 4 27.3382 34.1395 14.3734 -5.71629 20.1707 6.74573 +3345 6 9.99603 27.3398 13.3337 -11.5184 -70.0362 -20.4383 +3346 4 9.96963 28.1856 12.9595 -3.0362 48.3298 -16.8459 +3347 4 9.789 26.7159 12.5598 12.8825 26.2078 29.4693 +3348 6 2.39106 26.8936 37.3456 -18.0299 -5.48602 7.48259 +3349 4 2.24944 26.7597 38.2955 12.6258 0.126767 -1.18485 +3350 4 3.33209 26.9598 37.1993 18.2818 -0.192027 1.55797 +3351 6 33.3384 17.273 36.7956 -4.69576 6.00605 30.6641 +3352 4 32.3777 17.4022 36.9421 6.35755 -1.66054 -12.3647 +3353 4 33.5147 17.1107 35.8745 -6.55426 -0.461729 -19.8283 +3354 6 10.6704 18.7989 9.29568 -2.62714 4.796 -4.28658 +3355 4 10.7729 18.8103 8.31395 -3.57004 -0.312677 18.1362 +3356 4 10.9356 19.679 9.6198 -4.15772 -1.10699 -11.1079 +3357 6 8.58029 27.4085 3.13543 -0.646896 -38.9365 14.7517 +3358 4 8.62134 27.4642 4.10772 -2.35878 18.0768 -8.00568 +3359 4 8.54298 26.4189 3.06204 -3.80038 30.3142 -4.62402 +3360 6 40.6121 33.9148 14.3433 -13.4775 28.2536 -12.7531 +3361 4 40.8898 33.2957 14.9932 8.13038 -23.145 12.8628 +3362 4 40.1237 34.5547 14.8716 -1.64981 1.12342 -7.13376 +3363 6 54.0126 16.7742 13.6402 -25.2384 12.1291 10.4483 +3364 4 54.0311 17.2666 12.8352 12.7766 5.78776 -30.0788 +3365 4 53.1083 16.9555 13.9311 3.38038 0.740926 17.4694 +3366 6 39.1613 38.4947 7.40674 -49.2832 -1.36929 38.9537 +3367 4 38.8094 38.4839 6.52049 1.87105 5.40513 -14.0728 +3368 4 38.3203 38.5292 7.99504 41.7155 2.10662 -28.5328 +3369 6 42.2152 33.6749 29.0207 -49.4578 14.7313 -27.4402 +3370 4 42.0113 34.6279 28.8262 15.7605 -21.0767 3.4048 +3371 4 41.3749 33.2313 28.6743 34.021 9.03137 24.2205 +3372 6 2.84529 0.06018 20.1342 1.75144 -0.125494 -5.27144 +3373 4 2.85876 0.453048 19.2323 -10.3946 -7.40064 8.89792 +3374 4 1.95714 41.5787 20.3005 13.5701 9.63706 -6.70109 +3375 6 24.9846 26.9367 24.435 4.97654 17.1262 30.4362 +3376 4 25.3707 26.0628 24.5275 -2.48626 -13.7157 -10.817 +3377 4 25.1946 27.3852 25.2847 -1.69157 -3.92554 -20.3381 +3378 6 13.6202 33.989 7.00835 -29.3159 10.7937 -13.6787 +3379 4 14.4707 33.6317 6.76766 5.19255 -3.31821 -12.8703 +3380 4 13.1262 34.2356 6.16936 24.7045 -4.21039 25.9053 +3381 6 17.6361 31.8361 3.38698 11.6752 63.8731 -26.646 +3382 4 17.3765 32.06 2.46015 3.81419 -8.12146 27.658 +3383 4 17.5414 30.922 3.45915 -17.4061 -53.1647 5.72422 +3384 6 31.114 29.8463 35.9142 20.4735 12.0385 -23.871 +3385 4 30.4046 29.6578 36.4892 -25.9224 -10.1565 23.4082 +3386 4 31.8798 29.3863 36.2596 4.49336 -0.641295 3.24883 +3387 6 31.4544 1.69927 1.93203 61.0942 61.1307 23.4408 +3388 4 30.847 1.03155 1.81447 -56.5376 -48.8621 -2.33617 +3389 4 31.1234 2.33851 2.60628 -4.67927 -17.7811 -18.4359 +3390 6 13.7206 9.35179 12.308 -20.4886 -14.5553 22.3614 +3391 4 13.8994 10.2254 12.0406 16.2488 33.284 -13.5816 +3392 4 13.1923 9.47724 13.1212 6.47756 -14.062 -7.29461 +3393 6 15.2915 15.1706 12.1407 -39.3514 -20.6771 -15.8676 +3394 4 14.288 15.1355 12.0691 34.6095 3.19954 13.2467 +3395 4 15.5721 14.5705 11.433 2.70369 1.94224 0.817449 +3396 6 44.9298 30.4448 13.0945 -83.0621 -13.8007 20.4391 +3397 4 45.2326 30.6692 13.9612 22.7288 5.76966 14.7184 +3398 4 45.5619 30.4921 12.4362 58.1466 4.79773 -38.6719 +3399 6 35.1494 37.6283 24.8564 -28.9971 -18.9514 34.2227 +3400 4 34.5453 38.351 25.1691 15.7809 -12.2194 -9.31628 +3401 4 34.8969 36.8477 25.46 15.2444 28.3361 -22.0595 +3402 6 43.9018 19.2999 12.9893 -4.23684 -28.8047 14.7243 +3403 4 43.7111 18.3276 12.9437 8.07938 21.0179 -2.3859 +3404 4 44.434 19.3703 13.8064 -8.2748 4.27416 -6.23054 +3405 6 14.1928 27.3824 16.8974 17.9721 24.801 -15.5057 +3406 4 13.3941 26.8971 17.049 -12.9837 -13.2841 -1.45311 +3407 4 14.075 27.8458 16.0392 0.928992 -14.2323 10.6565 +3408 6 5.07867 37.4759 15.7278 -19.2695 5.34987 61.0101 +3409 4 5.83402 37.4907 16.3496 5.41141 -1.20808 -8.02024 +3410 4 5.40595 37.3511 14.8725 27.2981 -13.142 -45.6678 +3411 6 35.4792 36.9736 33.2279 -33.1303 3.22524 14.2013 +3412 4 36.4062 37.0387 33.1707 43.394 6.70104 -6.41693 +3413 4 35.2647 37.5361 33.9926 -10.1497 -5.08286 -5.32556 +3414 6 6.63713 31.7122 32.9951 -15.6769 -13.4095 -29.903 +3415 4 7.30356 31.0631 32.7808 0.413821 -11.0386 -1.85208 +3416 4 7.01801 32.1732 33.7097 9.96672 21.2943 24.541 +3417 6 31.2686 20.2272 25.4717 1.63607 -11.2998 14.888 +3418 4 30.457 20.1188 26.0175 18.7046 8.55246 -6.40474 +3419 4 30.9671 20.3507 24.5747 -9.02709 8.2981 -6.80006 +3420 6 54.9594 26.0897 7.3541 -26.2324 -3.52234 4.1817 +3421 4 54.3149 26.536 6.76189 8.45344 -4.14623 9.81761 +3422 4 54.4064 25.6921 8.06559 9.60693 6.10548 -13.0393 +3423 6 17.8786 35.1581 24.3912 -48.4608 -31.2574 -23.2844 +3424 4 17.9034 34.576 25.1672 15.4891 12.513 -1.90366 +3425 4 17.14 34.695 23.8716 34.0055 23.8611 10.1154 +3426 6 49.1404 3.30993 19.753 -11.7437 -5.45724 -22.9314 +3427 4 48.7379 4.07245 20.162 -0.785462 12.6857 6.5087 +3428 4 49.8408 3.03849 20.3377 4.84054 -6.57183 8.59361 +3429 6 30.2791 35.6014 13.4902 -0.275976 1.62471 9.45881 +3430 4 29.4038 35.7322 13.1068 5.01216 -3.78726 -8.18413 +3431 4 30.1007 35.4484 14.4302 1.26073 -0.50544 -4.60872 +3432 6 43.3857 25.8788 41.6729 -28.3599 -13.2186 -4.43344 +3433 4 44.0236 25.6058 41.0289 13.0372 -2.28568 -15.7328 +3434 4 43.8192 26.4334 0.378509 18.4346 21.3926 23.5205 +3435 6 21.1033 23.1572 6.40534 -12.8895 6.60285 13.2505 +3436 4 21.2833 23.9599 6.94372 3.68538 -20.4677 -7.26612 +3437 4 21.2354 23.4378 5.50624 8.61756 6.39287 -19.4039 +3438 6 54.6209 21.1977 19.0953 -9.4905 16.5472 15.3455 +3439 4 0.355231 21.543 19.6762 -10.082 -5.94448 -19.8865 +3440 4 53.803 21.6498 19.4211 22.178 -8.62035 -3.94206 +3441 6 13.8696 38.9444 18.7589 -0.408574 -9.95072 10.686 +3442 4 13.5473 38.5195 19.5701 -4.79749 -3.34053 -10.6661 +3443 4 14.2783 39.7511 19.0654 -4.68159 17.5572 -2.41189 +3444 6 39.1837 2.73799 39.6933 -2.22487 -14.248 -19.2211 +3445 4 38.5048 2.18054 40.1045 3.50502 9.25929 9.72195 +3446 4 39.1752 2.3966 38.7788 -3.09486 7.3066 6.14055 +3447 6 43.2236 33.8218 8.83748 -23.7799 54.6507 -8.87946 +3448 4 43.1776 32.9835 9.22653 -2.14792 -45.6212 21.4927 +3449 4 42.4318 34.327 9.18683 27.5752 -12.6709 -4.85681 +3450 6 23.0768 16.6786 12.1043 19.2201 -8.5648 -22.0864 +3451 4 23.4688 16.2415 11.3109 -7.42341 7.06352 19.0042 +3452 4 22.1329 16.714 11.9048 -3.02708 6.60369 6.72608 +3453 6 40.7875 26.1445 36.3165 -31.0446 26.1707 15.63 +3454 4 40.1182 26.8831 36.2336 22.2291 -27.8038 4.66075 +3455 4 41.0346 25.9172 35.4285 12.0382 -0.567557 -16.236 +3456 6 15.1503 11.6728 19.298 -10.8743 -20.3409 15.6657 +3457 4 15.4707 12.2619 18.6272 13.0208 17.9076 -10.0848 +3458 4 15.518 11.9699 20.1418 -0.780585 5.28883 -4.88637 +3459 6 9.8485 29.8084 31.3808 31.6725 31.0987 -15.032 +3460 4 10.6075 30.172 31.8684 -9.75043 -12.6573 12.7307 +3461 4 9.98584 30.2945 30.5336 -20.1344 -22.7331 8.89086 +3462 6 2.12557 30.0341 25.264 -3.96851 -24.8252 -11.595 +3463 4 2.04755 29.1979 25.7442 2.8488 12.5065 4.07713 +3464 4 2.06741 29.7398 24.3306 5.27272 21.1251 20.17 +3465 6 49.0124 10.6515 7.04668 12.8278 -6.79775 19.6819 +3466 4 49.7765 10.456 7.62014 -4.12072 9.88663 -9.32692 +3467 4 48.4954 9.84699 7.16976 -12.5497 -3.43755 -7.74842 +3468 6 38.6385 34.4247 32.4851 8.7415 15.3068 2.26745 +3469 4 38.2449 35.2411 32.8392 7.79483 -2.42751 -9.0272 +3470 4 38.3877 33.7513 33.1114 -5.41613 -8.85245 5.88093 +3471 6 24.2967 24.7175 4.7858 -13.8074 20.2372 -8.25903 +3472 4 24.5879 23.8747 5.12331 8.49271 -10.4438 10.0312 +3473 4 24.0688 25.3355 5.52385 7.10746 -21.4288 -14.6014 +3474 6 44.0211 23.587 33.7713 -18.8641 -18.6234 -6.9532 +3475 4 43.6265 23.0569 33.047 -3.30007 6.44469 22.3225 +3476 4 44.7839 23.9213 33.3479 32.8249 22.1868 -7.88886 +3477 6 45.135 31.9539 26.6318 17.8742 -16.5206 -32.2352 +3478 4 44.6965 32.0125 27.458 -12.8805 4.46476 28.7394 +3479 4 45.0195 31.023 26.337 -1.34861 17.8758 10.4404 +3480 6 52.0545 6.36303 22.865 -1.87051 -30.929 -4.90791 +3481 4 51.4549 5.58836 23.0553 13.7734 29.2588 0.606927 +3482 4 51.4955 7.14596 22.8951 -3.5837 -3.73437 -5.39564 +3483 6 5.1124 17.7016 30.4663 -17.3022 -2.39818 -4.94531 +3484 4 5.57517 17.705 29.6436 5.33167 -14.42 -26.4334 +3485 4 5.6774 18.2653 30.9495 12.7188 16.8745 32.2475 +3486 6 48.5399 17.0091 6.52669 31.3107 25.6813 -22.3666 +3487 4 48.2466 16.108 6.56632 -4.44525 -18.5722 0.0807757 +3488 4 49.3123 17.0767 5.87973 -32.0368 -4.22047 21.2267 +3489 6 13.8017 31.3286 23.4652 -45.3568 -0.340859 23.461 +3490 4 14.0246 31.2001 24.3905 13.6426 -1.74144 -0.768444 +3491 4 14.5269 31.1963 22.8948 44.8358 -8.96568 -14.3918 +3492 6 28.4984 33.4231 26.025 30.2115 45.129 -4.70205 +3493 4 28.7629 32.7421 25.4284 0.749934 -18.6264 -12.7861 +3494 4 27.7356 33.1626 26.4825 -33.9251 -20.2776 22.3239 +3495 6 9.04101 22.9533 11.0101 4.17271 5.63899 8.67886 +3496 4 9.24243 22.776 10.0879 9.05926 -1.29962 -0.957415 +3497 4 9.84172 22.774 11.5341 -6.79246 0.647577 -9.3095 +3498 6 40.5624 4.0706 26.5792 43.7479 -58.1273 15.512 +3499 4 40.0377 4.03321 27.356 -14.6911 0.39925 31.4188 +3500 4 40.1771 4.74143 26.1095 -33.6389 57.2603 -43.6855 +3501 6 17.0606 37.9689 20.9328 24.9068 -2.83666 19.2437 +3502 4 17.7492 37.7057 21.5806 -0.23423 0.332892 -22.3637 +3503 4 16.3 37.9671 21.4825 -28.3901 -0.1668 6.57955 +3504 6 31.9758 6.36253 14.1925 -47.1359 -2.961 8.2158 +3505 4 31.6652 5.47044 14.4516 -0.57512 5.53961 -9.89258 +3506 4 32.9075 6.27907 14.242 33.1863 -3.34593 -3.73058 +3507 6 29.3613 34.9484 39.6522 -7.7658 6.78361 -10.4711 +3508 4 29.4154 34.7255 40.5688 2.48129 -3.65799 19.6008 +3509 4 28.4079 35.1232 39.5563 9.75382 -5.50564 -9.65046 +3510 6 22.5642 2.93231 32.1024 7.89654 -13.571 4.24933 +3511 4 23.152 3.60479 31.7467 -0.797152 8.5773 -0.128413 +3512 4 22.8746 2.10235 31.6905 -8.86372 14.3523 0.842504 +3513 6 51.7365 19.0888 24.8036 24.4352 10.6631 34.2631 +3514 4 52.2011 19.3182 25.6664 -22.8444 -5.9403 -33.5217 +3515 4 52.2256 19.5376 24.1035 -3.13425 5.18677 -1.50107 +3516 6 32.1309 13.661 24.2221 8.32979 -1.22201 -48.3483 +3517 4 32.1718 13.7834 25.1379 3.34806 7.10631 53.6256 +3518 4 31.2192 13.5434 23.9915 -25.9097 -1.66347 2.1781 +3519 6 9.49478 30.1756 28.7975 -1.02802 7.68553 8.51386 +3520 4 8.9614 29.4447 28.4635 3.13242 -3.87437 -3.11369 +3521 4 9.76139 30.7024 28.0341 -4.99689 -6.39164 -2.13333 +3522 6 31.3017 3.1328 24.0821 -2.56057 -13.3126 7.41322 +3523 4 30.8642 3.97896 23.9468 1.03353 -0.10231 -3.56587 +3524 4 32.1597 3.13825 23.6386 1.18226 10.803 -0.447916 +3525 6 2.13915 19.8328 36.4477 43.9795 26.8161 3.66972 +3526 4 3.0929 19.9274 36.115 -41.9598 -16.8793 8.64164 +3527 4 1.76662 18.9777 36.2517 -5.24508 -9.86619 -11.2286 +3528 6 36.9558 16.7701 14.0992 8.10199 -24.1685 -1.60142 +3529 4 37.0878 17.1202 14.9938 -3.44507 3.84646 -3.58016 +3530 4 37.3137 15.854 14.1066 -5.27996 15.1268 -1.92478 +3531 6 1.82451 11.1811 6.08431 4.75441 9.84221 -14.5701 +3532 4 1.68522 10.3449 6.52934 -2.64515 -5.74712 4.44833 +3533 4 1.45572 11.848 6.66197 -6.16769 2.71123 7.45582 +3534 6 43.1467 36.8536 25.2684 -4.34259 -25.2275 5.76074 +3535 4 42.489 36.6679 24.5813 -1.65581 9.08703 8.09798 +3536 4 42.9757 36.1566 25.9418 7.67001 18.3814 -10.5814 +3537 6 32.1358 5.54258 7.00813 -0.159667 5.03525 -3.02009 +3538 4 31.8447 4.70695 7.37259 1.76357 -8.94122 3.22744 +3539 4 31.6184 6.21523 7.45425 -7.92944 5.35442 3.67752 +3540 6 15.0738 21.498 41.5176 2.48253 -6.99424 4.64434 +3541 4 14.4083 21.441 0.286083 -5.89506 -4.91034 13.0846 +3542 4 14.6326 22.02 40.8608 1.523 7.8898 -22.5967 +3543 6 37.0299 36.0573 5.68999 -1.26402 -4.33671 -4.68257 +3544 4 36.8992 36.8706 5.1864 -9.04185 9.38437 4.54051 +3545 4 36.6368 36.1345 6.57983 4.68584 5.64444 -6.17041 +3546 6 39.6378 22.8733 0.344261 -10.4835 1.90991 -1.04201 +3547 4 39.8967 23.7127 41.8596 6.32696 2.65577 1.7872 +3548 4 39.7641 22.9598 1.30287 2.84221 -4.68177 2.22816 +3549 6 18.471 23.1695 5.24444 18.17 13.8994 5.32385 +3550 4 18.2426 24.0888 5.07969 -12.1406 8.45165 -11.681 +3551 4 19.3434 23.2774 5.65727 -5.17221 -14.3673 2.51868 +3552 6 34.4951 26.4012 0.415196 -24.2262 -21.8504 23.5375 +3553 4 33.9567 27.1096 0.873351 15.2264 -25.8266 -5.88921 +3554 4 34.3584 25.5285 0.919462 6.17703 40.7497 -12.3351 +3555 6 28.1538 26.089 40.6186 -44.0465 -12.7539 23.8091 +3556 4 29.0676 25.9468 40.8623 9.74545 0.451611 8.45277 +3557 4 27.5517 25.6856 41.3354 31.2048 15.0133 -28.9196 +3558 6 41.7541 4.40312 30.2348 -21.1804 7.97019 15.7848 +3559 4 42.5951 3.9554 30.1474 10.5948 -6.90465 6.49815 +3560 4 41.6197 4.66064 31.1807 9.39609 -4.15263 -13.0838 +3561 6 4.45746 8.30422 29.123 17.0584 8.0822 12.8675 +3562 4 3.72424 8.78851 28.7689 -20.5564 0.917363 -10.5697 +3563 4 4.90241 9.00738 29.631 2.39094 -12.8625 -4.67793 +3564 6 12.9051 9.61174 32.1485 9.54391 19.7002 1.20842 +3565 4 12.5238 8.90328 31.6499 -4.6135 -18.7028 0.941221 +3566 4 13.4507 9.29961 32.8815 -5.77341 -6.01915 -0.606497 +3567 6 48.6524 16.2364 1.45279 -39.5117 19.3379 22.5337 +3568 4 49.5656 16.3395 1.57323 44.82 -2.42546 -4.76282 +3569 4 48.322 16.6449 2.29127 -2.06599 -18.2277 -23.678 +3570 6 26.4391 39.9942 21.1964 -5.73 55.7886 4.05886 +3571 4 27.1886 40.6225 21.0926 -13.7426 -7.13397 8.25982 +3572 4 26.7825 39.1793 20.9147 12.833 -38.7313 -7.54244 +3573 6 35.8074 4.09236 9.03492 -45.4698 -15.3304 -15.5709 +3574 4 35.5046 4.67089 8.30824 2.24043 1.80806 6.22839 +3575 4 34.9768 3.81452 9.52186 26.5657 10.3238 -8.47709 +3576 6 52.6895 3.55751 27.8666 50.2867 -19.9176 -34.5196 +3577 4 53.5586 3.5996 28.3549 -33.5645 -3.53647 -1.9565 +3578 4 53.0019 3.22463 26.9489 -24.4009 21.759 36.9675 +3579 6 48.3192 26.6913 27.3954 13.1896 -37.7442 -6.45526 +3580 4 48.9722 25.929 27.4853 -22.116 34.446 0.770506 +3581 4 48.7243 27.4862 27.7371 6.43066 9.80699 11.7315 +3582 6 24.507 4.96042 18.7259 -17.59 -10.4057 14.9036 +3583 4 24.0519 4.20246 19.1729 14.2279 16.3534 -10.8515 +3584 4 23.9406 5.7442 18.8517 8.31711 -9.56192 -0.149656 +3585 6 24.0493 12.473 28.7688 20.4432 11.2466 2.34496 +3586 4 23.2439 12.9627 28.9427 -11.3477 -3.77152 -2.6943 +3587 4 23.8404 11.6087 28.4204 -6.74951 -3.90152 -5.01594 +3588 6 40.1637 27.7353 40.8087 -33.5791 -9.4694 0.953173 +3589 4 40.5641 26.9832 41.236 1.78301 2.25495 0.260865 +3590 4 39.2218 27.4214 40.7917 21.7476 20.7917 -9.34619 +3591 6 11.9335 13.5538 26.9488 -1.21599 4.57236 -11.9259 +3592 4 11.0364 13.8177 27.1576 -7.67129 -6.9102 2.53909 +3593 4 12.2164 12.9501 27.6309 4.70555 -13.4351 6.55277 +3594 6 52.1924 29.5424 41.3942 11.5626 -24.8936 -19.0003 +3595 4 51.8104 30.1965 0.050158 4.44506 23.3375 14.6186 +3596 4 53.1351 29.3771 41.6391 -10.5303 1.44862 4.74126 +3597 6 17.4882 19.0285 39.1853 -8.07927 32.7478 0.0743051 +3598 4 17.5012 19.6463 39.9647 -0.891206 -23.8414 -20.0908 +3599 4 17.261 19.5796 38.3923 8.05332 -16.519 21.1694 +3600 6 46.2326 27.6801 33.704 6.45393 -8.86534 7.23017 +3601 4 46.097 28.3723 33.048 -4.6559 5.79968 -1.93617 +3602 4 45.5979 27.7746 34.4233 -3.33861 16.4707 5.34235 +3603 6 35.8364 29.5448 5.62541 9.64171 -18.9009 -6.27826 +3604 4 35.5566 29.3199 4.72548 3.62776 14.0584 -3.56087 +3605 4 35.3944 30.354 5.86953 -6.57081 16.5188 2.47276 +3606 6 47.2881 25.7744 30.172 -6.62968 25.0044 -44.0548 +3607 4 48.1218 25.8653 29.6696 -5.94381 -7.49802 14.0131 +3608 4 46.6882 26.3745 29.6449 8.85802 -15.1094 17.4745 +3609 6 51.3842 12.359 20.0239 24.4626 17.3052 -5.31346 +3610 4 50.8707 12.833 19.3583 -10.0057 -7.98386 3.51527 +3611 4 50.8448 11.6564 20.3722 -11.0446 -8.70835 7.6307 +3612 6 41.976 18.3776 28.9581 25.2971 -7.26912 -18.3725 +3613 4 42.7018 17.9973 28.405 -17.3573 7.64094 3.96866 +3614 4 42.4517 18.9921 29.5246 -2.74764 -0.293653 0.793262 +3615 6 53.6043 6.48027 7.50524 -23.0657 -32.6432 -30.9738 +3616 4 53.1601 5.59498 7.33399 18.2827 28.6912 7.08019 +3617 4 53.6632 6.576 8.44633 9.6706 -3.87944 16.2616 +3618 6 9.90786 10.6094 26.7582 6.17728 8.73826 28.1859 +3619 4 10.299 10.3755 27.6331 -6.59671 -6.24018 -20.7073 +3620 4 9.65116 11.5299 26.9247 0.732239 -5.98194 -12.944 +3621 6 9.31054 39.3957 29.7756 40.7644 23.7808 19.8799 +3622 4 10.1982 39.3563 30.2561 -34.3316 0.809436 -14.8313 +3623 4 8.83679 40.1565 30.1832 5.55001 -15.1294 -12.8037 +3624 6 33.4099 4.77839 0.03236 -17.6047 -18.7695 14.8321 +3625 4 33.6454 5.53147 41.4176 15.8926 12.9618 -7.52592 +3626 4 34.0969 4.09847 41.8942 -0.186489 10.0102 -3.03658 +3627 6 35.7116 10.6673 34.2398 36.7653 -21.2814 -15.2586 +3628 4 35.2554 10.867 35.0388 -18.8422 0.575424 27.4634 +3629 4 36.4577 10.0619 34.4978 -21.6361 17.9445 -5.28322 +3630 6 15.2039 17.4016 19.1867 13.7018 -34.0248 -48.7675 +3631 4 15.5709 16.9982 18.3093 -23.7907 16.5473 43.0322 +3632 4 14.2523 17.472 19.021 -2.02403 4.48523 -0.714523 +3633 6 17.4757 37.6682 15.4227 -5.7624 0.927264 51.2416 +3634 4 17.0409 37.838 16.3209 3.67045 -5.85113 -35.7653 +3635 4 18.3529 37.3927 15.7202 1.879 4.38305 -13.464 +3636 6 26.263 8.20496 21.7043 -12.9193 13.0258 38.8746 +3637 4 26.2935 8.46487 22.6678 13.4631 -3.74504 -28.0146 +3638 4 25.3122 8.09558 21.5911 -4.90698 -1.77416 -12.6216 +3639 6 0.327844 9.89683 15.4174 -28.4002 -4.57955 -27.8061 +3640 4 1.20252 9.6859 15.1701 33.2298 -8.84956 3.25601 +3641 4 54.8213 9.3498 14.7471 -0.695723 21.8052 24.8209 +3642 6 13.451 40.6616 9.29616 -29.1589 -29.1317 3.11657 +3643 4 12.531 40.2581 9.2528 27.9164 27.237 1.6895 +3644 4 13.9533 39.998 9.7876 1.76749 3.89663 -1.50565 +3645 6 49.5605 25.9144 33.0102 6.77982 -23.7672 54.8124 +3646 4 50.0733 25.5846 33.8473 -25.1648 19.9091 -52.5505 +3647 4 48.6275 25.6453 33.15 14.5478 0.915879 -9.46863 +3648 6 37.0796 40.0419 26.4359 -26.9931 13.9721 12.3681 +3649 4 36.1882 39.5442 26.6099 42.8933 36.2545 -2.50818 +3650 4 37.051 41.026 26.6764 -12.8506 -44.3362 -9.04112 +3651 6 47.9916 17.8545 12.1553 -7.21137 29.6324 -37.7219 +3652 4 47.6652 18.6843 11.7058 6.42171 -29.0319 9.52509 +3653 4 47.7397 17.941 13.056 -8.12129 -2.80141 29.1943 +3654 6 27.9724 29.0571 34.165 6.45289 -21.5611 -2.40729 +3655 4 28.8948 28.8211 34.3683 -10.3018 1.8492 -2.91154 +3656 4 27.944 30.0064 34.1676 -0.713497 24.9251 0.854011 +3657 6 33.997 2.77014 13.2231 -35.3168 39.3397 6.14274 +3658 4 33.7592 2.40426 14.0871 -4.38792 -6.80294 -4.34532 +3659 4 34.7545 2.32608 12.931 40.4814 -27.3629 -5.76242 +3660 6 28.4454 36.033 11.4537 -30.811 -5.98685 22.1865 +3661 4 27.9997 35.3658 10.9161 0.521783 -1.73573 4.3727 +3662 4 28.9676 36.474 10.8303 31.7187 19.1344 -28.008 +3663 6 36.1836 11.3675 28.8638 -20.2526 -8.96451 -46.9053 +3664 4 35.201 11.3136 28.8426 17.393 5.15327 13.3727 +3665 4 36.3619 11.2493 27.8855 5.85658 3.26624 29.9739 +3666 6 24.7946 39.4802 16.9069 19.0937 3.96627 -8.4872 +3667 4 24.3751 40.345 16.9988 -5.97342 -3.52606 0.908874 +3668 4 24.9466 39.3518 15.9585 -10.9099 3.48913 2.54936 +3669 6 49.9504 8.05659 22.8451 -38.4139 -9.47108 -34.4931 +3670 4 49.9375 7.9588 23.7925 -16.1787 -3.75115 16.4902 +3671 4 49.0231 7.8493 22.4633 39.8101 3.17892 24.2331 +3672 6 52.1004 19.3469 10.2236 -1.12118 28.0811 1.24376 +3673 4 51.6057 19.3908 9.40186 -4.74475 -17.9853 -5.36861 +3674 4 52.3066 20.3081 10.2872 8.90847 -30.6944 7.30622 +3675 6 24.8344 15.8907 6.13046 -10.5287 3.62194 6.20212 +3676 4 24.2343 16.3288 6.78807 10.5214 -9.32926 -18.7028 +3677 4 24.4584 16.0701 5.24836 4.34413 4.47582 9.48796 +3678 6 49.3142 23.7074 8.6354 12.7826 -64.5552 32.8663 +3679 4 49.2168 22.9153 9.25307 13.1077 36.9849 -24.4484 +3680 4 48.4233 23.9587 8.46247 -20.5325 16.4959 -12.9251 +3681 6 0.200228 10.6387 32.1899 4.57462 9.08702 -50.3173 +3682 4 1.12405 10.3631 32.1441 4.84637 -6.06001 20.7538 +3683 4 54.8206 10.7585 33.0477 -1.25869 -8.0958 33.7963 +3684 6 12.5866 32.9145 13.2359 -45.84 -1.33101 12.3773 +3685 4 11.7384 33.4448 13.1799 26.1773 -16.8128 -1.90055 +3686 4 13.2757 33.4614 12.9111 20.4647 17.7705 -9.07485 +3687 6 21.729 32.5695 14.1172 -9.28791 -20.3928 5.37861 +3688 4 21.166 33.3661 14.1597 2.78901 -9.86158 3.94413 +3689 4 21.3002 31.8069 14.587 7.27427 31.5827 -10.8786 +3690 6 48.1522 34.8482 27.3304 1.15431 -17.6089 -40.5894 +3691 4 47.5385 35.1725 27.9994 -6.04073 -2.93057 -0.479876 +3692 4 47.6796 34.4132 26.5454 8.99615 21.2578 35.6726 +3693 6 45.6357 31.2393 36.095 -40.8957 20.4658 25.2026 +3694 4 45.8476 31.9489 35.493 1.2761 6.76392 -14.6383 +3695 4 44.8829 31.5945 36.6582 19.8537 -10.4851 -18.3708 +3696 6 46.2846 0.316369 14.3569 -23.6541 -29.5796 11.0344 +3697 4 46.2347 1.24867 14.1822 6.12226 14.592 -0.646978 +3698 4 47.172 41.8876 14.3137 22.6277 5.76419 -11.0491 +3699 6 14.3437 18.9821 40.2104 -25.2995 -33.3041 -15.9392 +3700 4 14.4094 19.2869 39.3238 4.54227 2.45102 -23.4893 +3701 4 14.593 19.7098 40.7196 18.3341 34.8836 33.2243 +3702 6 14.5595 1.13832 10.2184 21.0915 11.237 11.4523 +3703 4 15.4791 1.15983 9.85648 -24.9846 -0.242798 0.374642 +3704 4 14.0639 0.416501 9.81608 3.47586 -8.24251 -5.69878 +3705 6 34.4238 40.9137 13.0059 -4.24882 -26.6665 -25.0696 +3706 4 34.0907 40.4301 12.2099 6.6876 25.2293 12.1693 +3707 4 34.3655 40.2093 13.6737 -1.45879 20.9599 -0.365544 +3708 6 42.1372 25.6317 33.9946 32.9644 -29.1434 -4.32848 +3709 4 41.7256 25.3671 33.1599 -4.34041 1.82357 5.58197 +3710 4 42.8775 24.9612 34.1276 -26.6125 21.4128 -4.76888 +3711 6 29.2041 22.5904 40.0709 -12.2401 -3.24737 -11.2113 +3712 4 28.5312 23.0545 39.5673 2.40343 6.95864 -1.48823 +3713 4 29.0042 22.7646 40.9807 1.44808 0.219743 17.343 +3714 6 44.8039 18.6198 1.5029 3.83338 16.5679 14.3409 +3715 4 44.9659 19.0204 2.39019 -3.90529 -17.866 -14.3425 +3716 4 44.0478 19.1074 1.16429 2.25905 3.06151 -3.31671 +3717 6 4.48486 10.8191 23.9456 -47.6019 -35.9978 3.19751 +3718 4 5.13394 11.3869 23.6113 33.8353 31.137 -11.4748 +3719 4 4.52769 10.7271 24.8961 2.68899 9.9192 5.78369 +3720 6 6.46393 23.0191 29.0034 23.802 4.69353 23.6764 +3721 4 7.14249 23.0161 29.7285 -18.6834 17.7038 -21.9419 +3722 4 6.49076 22.0968 28.8008 -10.0115 -22.5628 -12.4771 +3723 6 39.7912 25.1434 32.5739 17.5205 -18.6836 -60.5647 +3724 4 39.6128 25.3468 33.4485 -16.6712 22.7672 53.7369 +3725 4 39.6667 25.9357 32.0325 -1.3786 -0.359445 4.68486 +3726 6 40.844 21.4875 8.87812 10.6958 -1.16061 -24.4784 +3727 4 40.753 21.3778 7.91779 -6.86728 3.07162 8.13114 +3728 4 41.3272 20.6946 9.13123 4.7165 -6.17308 11.2164 +3729 6 0.614957 1.42802 12.9561 35.282 30.4207 -35.1483 +3730 4 54.8795 1.90166 12.5287 -4.84596 -15.7095 11.3484 +3731 4 0.325279 0.716474 13.4972 -22.2917 -16.9379 18.816 +3732 6 32.6687 29.7155 23.4821 0.172893 -14.8348 21.3896 +3733 4 32.2937 28.8037 23.5347 8.27316 18.2339 -7.75927 +3734 4 32.5776 29.9928 22.5742 -5.86304 -0.191283 -15.879 +3735 6 12.5314 37.1515 20.4729 45.6241 64.5302 32.6184 +3736 4 13.0675 37.1561 21.3077 -14.1528 -0.638655 -18.1117 +3737 4 12.0966 36.3476 20.454 -27.4762 -63.6198 -6.10217 +3738 6 13.8924 14.5151 24.69 -3.15938 -4.02598 20.115 +3739 4 13.491 15.2498 24.2338 -4.44789 9.69439 -9.34194 +3740 4 14.0279 14.8194 25.6039 -0.281954 0.872924 -9.09093 +3741 6 17.5021 27.063 26.4741 18.9499 -7.93165 -17.7551 +3742 4 17.3645 27.9616 26.0981 5.20292 -20.1733 2.46217 +3743 4 18.105 26.551 25.8503 -19.0729 23.9469 15.4793 +3744 6 54.4877 9.53021 26.3477 -5.78247 7.96784 25.4661 +3745 4 54.0512 10.3733 26.628 8.34027 -15.1138 -9.49744 +3746 4 54.8923 9.139 27.1544 -8.60221 9.32804 -13.3813 +3747 6 33.6807 21.5011 24.9225 20.8165 12.7411 -37.5161 +3748 4 33.6447 21.5342 23.9109 -0.857654 -11.0597 35.2787 +3749 4 32.8481 21.1477 25.2212 -19.5227 -6.82771 5.56304 +3750 6 22.1475 35.2701 2.885 -1.57378 -2.18642 30.1771 +3751 4 22.1887 34.3602 2.5781 3.09514 -3.18559 -9.19859 +3752 4 22.1072 35.1817 3.87164 0.12039 0.813186 -18.6146 +3753 6 45.3027 5.41438 15.6133 24.4211 -32.124 17.7203 +3754 4 45.2073 5.06649 16.5292 -4.89018 16.6426 -14.7318 +3755 4 44.541 5.92364 15.3615 -17.3903 4.72304 -1.03383 +3756 6 5.67534 7.5869 16.981 -5.47297 6.8358 -20.2139 +3757 4 5.25896 7.81046 16.1225 6.35918 -0.232773 12.9215 +3758 4 6.51331 8.07041 16.9918 4.7107 -6.94883 2.60141 +3759 6 34.576 39.0992 27.2053 24.5889 13.5844 -33.9491 +3760 4 34.3093 38.4547 27.8221 -16.0328 -19.2876 29.327 +3761 4 34.0621 39.904 27.3046 -7.96056 4.01318 13.6593 +3762 6 32.7541 33.6107 34.2903 -12.2088 11.6467 -22.6039 +3763 4 32.1008 34.0277 33.6489 27.9813 -13.6615 23.3944 +3764 4 32.6574 34.0489 35.1447 -11.8345 -0.637226 -0.957772 +3765 6 31.0088 41.2052 32.3952 -16.5884 -4.13679 -5.08533 +3766 4 30.2065 41.1942 32.9317 -1.71273 -1.00977 6.80252 +3767 4 30.9738 0.147898 31.9828 5.47722 15.337 -6.15299 +3768 6 7.65161 1.58314 27.1492 34.9115 -9.04616 -23.8477 +3769 4 8.49581 1.43905 26.61 -35.9655 -7.00487 18.1392 +3770 4 7.51162 2.51613 27.0476 -4.48076 16.5289 1.77021 +3771 6 0.884173 22.0999 37.8474 19.5684 -22.3581 -15.9684 +3772 4 1.29289 21.3236 37.3582 -15.3878 24.821 16.8607 +3773 4 1.19208 22.8872 37.3739 -1.97361 -3.14502 -0.467946 +3774 6 7.41204 11.1157 19.2314 -38.1481 -15.0427 -1.85178 +3775 4 7.53858 12.0593 19.2468 12.5581 17.6457 8.19935 +3776 4 8.2604 10.6916 19.3015 17.9889 5.14781 -4.65775 +3777 6 43.7858 12.4956 37.3097 0.920036 9.73958 -3.1733 +3778 4 43.9612 12.5094 36.3537 -0.436236 -2.21513 6.60981 +3779 4 44.6264 12.7918 37.692 -0.443403 -7.75914 -0.361508 +3780 6 29.0868 33.5248 36.1867 6.33086 18.8505 -43.8567 +3781 4 29.87 33.99 35.8176 -18.9328 -5.41066 10.4629 +3782 4 29.4633 33.0358 36.8874 15.3521 -14.5291 31.9885 +3783 6 14.802 4.59099 3.93345 20.4849 22.8827 12.2406 +3784 4 14.3757 4.0439 3.27797 -5.14737 -6.71868 -8.73832 +3785 4 15.6594 4.91612 3.57855 -16.4986 -14.1515 -5.85747 +3786 6 39.0551 6.39795 6.38864 -31.6963 1.09254 42.8867 +3787 4 39.3692 7.21691 6.04781 17.6944 18.3081 -17.2196 +3788 4 39.3538 5.69048 5.84285 10.6785 -8.50098 -20.4551 +3789 6 22.2123 37.9977 40.776 -14.7699 -23.2033 -28.4168 +3790 4 22.4586 38.8695 40.5021 9.68098 25.7962 -2.3277 +3791 4 22.4791 37.9118 41.6765 7.85923 -2.07179 26.9545 +3792 6 4.44877 23.2867 6.14309 -1.92846 -21.7963 14.7751 +3793 4 3.85981 23.8785 6.59389 -8.34079 22.3777 -5.30491 +3794 4 4.15148 22.4458 6.53602 18.5324 -1.87236 -10.5169 +3795 6 12.4298 23.7885 9.24819 15.5635 1.24594 19.7483 +3796 4 11.6299 23.5219 8.81427 -22.2296 0.449899 -3.14002 +3797 4 12.2156 24.1823 10.1208 2.55292 -1.37139 -18.7826 +3798 6 46.4922 15.2589 16.9667 3.22745 3.94864 2.0367 +3799 4 47.1791 14.9867 16.3488 -1.59454 -10.7105 -10.6804 +3800 4 46.8221 16.1143 17.2497 1.89409 2.98219 12.0057 +3801 6 34.1117 27.1644 19.7797 24.4736 -11.2812 21.2279 +3802 4 34.8774 26.5238 19.7962 -19.6491 14.1094 -6.20677 +3803 4 34.0324 27.4806 20.6991 -2.21978 -4.312 -16.0235 +3804 6 46.9479 13.2121 35.1109 14.7829 18.0264 15.8687 +3805 4 47.3232 14.0654 34.8894 8.1348 3.75559 6.81177 +3806 4 46.5576 12.9943 34.2929 -17.7211 -19.0679 -23.646 +3807 6 50.5883 18.7922 12.536 -4.97475 -8.40096 -18.6689 +3808 4 49.7377 18.4417 12.2063 9.85466 0.19572 8.20723 +3809 4 51.2037 18.6585 11.7837 -7.44169 10.1395 9.07394 +3810 6 32.4871 12.6357 31.9554 3.75694 -28.5712 -45.9238 +3811 4 32.607 11.6542 31.8864 5.47128 21.8321 9.55763 +3812 4 32.4011 12.8494 32.8587 -4.02679 2.16968 41.7104 +3813 6 6.20502 19.6778 10.0162 1.71901 21.9334 16.0314 +3814 4 6.41826 20.2441 9.25697 6.75258 -1.0862 1.44387 +3815 4 6.08129 20.3112 10.7738 2.93045 -16.0896 -19.0741 +3816 6 21.5254 21.5246 2.44441 10.1652 3.23891 -24.6245 +3817 4 21.7373 21.5014 1.49425 -3.90993 5.22039 4.49463 +3818 4 22.0841 20.8004 2.76184 -10.1442 1.98878 12.5692 +3819 6 38.3901 23.0895 17.1987 11.9637 -29.1373 -23.0023 +3820 4 38.7115 23.1739 16.2902 2.30233 23.4463 5.8212 +3821 4 38.6091 22.1461 17.2941 -10.4226 8.48715 23.8901 +3822 6 29.6992 24.9636 22.2212 38.6917 -37.4999 -9.7813 +3823 4 30.2244 25.0209 22.9989 19.9484 -5.9881 25.7874 +3824 4 29.0295 25.5321 22.4534 -63.588 46.0104 6.14599 +3825 6 30.2959 21.4331 37.7732 -36.6703 24.7369 -1.55525 +3826 4 30.3833 21.3736 36.7928 -5.6984 1.01251 23.2154 +3827 4 29.3642 21.7906 38.031 44.833 -25.8334 -23.6526 +3828 6 11.8968 11.712 16.3062 -52.2626 -16.509 -42.1992 +3829 4 11.3487 12.2512 16.8737 -4.04714 4.99791 6.8918 +3830 4 11.2749 11.5458 15.4981 35.5887 6.11969 38.645 +3831 6 5.69762 16.9728 10.4703 1.06122 -0.586779 5.28994 +3832 4 4.99177 17.1708 11.0979 -1.96678 -11.04 -5.71485 +3833 4 5.85288 17.8179 10.0528 3.40155 4.97172 -3.96907 +3834 6 41.7052 34.1635 35.8846 2.77529 22.9845 38.2917 +3835 4 41.9958 35.0267 36.2582 -8.6238 -19.1969 -5.00662 +3836 4 41.6615 34.3005 34.9574 -2.57818 -0.630621 -34.674 +3837 6 33.7668 1.16041 30.1021 -7.73366 -5.3538 60.0773 +3838 4 32.8437 1.27671 30.3431 -6.56672 10.3256 -18.6068 +3839 4 34.0939 1.04339 31.0463 15.1522 -1.22783 -40.312 +3840 6 50.3589 18.6227 36.9888 29.2523 22.0538 -2.88024 +3841 4 50.1022 18.8636 37.8788 -6.7252 3.81489 7.59342 +3842 4 49.7597 17.9698 36.6907 -30.5426 -29.286 -11.4073 +3843 6 24.6818 24.2557 40.239 -30.3362 18.6852 9.52233 +3844 4 23.7683 24.4347 40.5809 21.1328 -2.57181 -5.50386 +3845 4 24.791 23.3075 40.3447 2.5826 -1.14956 -5.51696 +3846 6 37.3025 22.0306 23.2304 -1.24857 -1.55203 26.5345 +3847 4 37.0034 21.8174 24.1364 -3.77965 7.42086 -11.5868 +3848 4 37.7677 21.2337 22.9852 8.84969 -1.31238 -13.2672 +3849 6 48.4163 40.4951 28.9695 -6.68628 11.813 -16.9736 +3850 4 49.0084 41.2243 28.7075 -10.6266 -4.31108 -6.63999 +3851 4 47.6767 40.479 28.3098 12.2088 -0.876211 11.6705 +3852 6 24.8524 8.74511 16.566 -5.47802 -1.24744 16.6444 +3853 4 25.3154 9.32041 17.1898 2.58295 -0.80606 -7.28092 +3854 4 25.3735 7.93816 16.4942 1.51819 -5.71343 -7.74972 +3855 6 19.2312 23.0154 32.4581 7.29767 -10.2486 -2.08042 +3856 4 18.4295 23.4489 32.1618 3.75321 4.57429 -6.83594 +3857 4 18.9208 22.4103 33.1253 1.01223 -4.21105 8.69504 +3858 6 3.33807 21.6805 22.4551 -46.3933 -7.60477 16.0737 +3859 4 2.65604 22.1286 23.0335 23.3212 -20.9163 -13.0515 +3860 4 4.02869 22.318 22.3903 27.1551 13.0827 -5.07429 +3861 6 10.2258 20.3371 12.829 -8.54969 -20.6717 -8.68144 +3862 4 9.56384 20.8338 13.3253 4.28314 2.73019 -3.94148 +3863 4 9.70568 19.6401 12.367 8.3544 15.6282 9.01344 +3864 6 9.53393 0.668964 25.3385 8.23748 17.1946 -9.08311 +3865 4 10.3992 0.538209 25.8183 -20.1327 16.9559 -17.4439 +3866 4 9.57635 1.38514 24.6117 12.9812 -33.3008 29.4344 +3867 6 10.6624 40.712 9.64369 -16.6479 -8.09828 -30.6343 +3868 4 10.6692 41.3905 10.303 1.51816 10.4523 18.0663 +3869 4 9.97599 41.0031 8.99599 12.0328 -9.66263 16.6565 +3870 6 46.359 25.2248 32.6769 -14.7838 37.2607 37.796 +3871 4 46.1367 26.0735 33.2154 13.6855 -48.6436 -31.9122 +3872 4 46.6282 25.5659 31.8216 4.36769 -3.83668 -6.22015 +3873 6 38.9431 3.2028 23.1016 18.0409 -17.6687 24.963 +3874 4 38.0396 3.32435 22.9005 -28.138 13.963 -19.732 +3875 4 38.8834 2.64883 23.9052 13.1186 5.8311 -6.82495 +3876 6 33.334 23.6417 36.8871 -1.6197 -14.346 14.9842 +3877 4 32.7695 23.6175 37.7211 18.6046 10.6207 -30.6843 +3878 4 33.5528 24.5621 36.6745 -4.59115 1.63353 1.59233 +3879 6 51.9355 33.3272 25.435 24.4931 61.1901 -39.0042 +3880 4 51.4286 33.1494 26.1943 -20.5556 -13.8295 37.3068 +3881 4 51.9313 34.3506 25.3627 -2.33157 -52.0679 -5.38276 +3882 6 32.1777 25.0215 33.1655 -4.40266 21.2191 -9.05445 +3883 4 32.7541 25.8194 33.0841 -10.7751 -17.7804 3.95932 +3884 4 31.2703 25.3891 33.0319 13.5135 -10.8842 0.697404 +3885 6 51.2858 27.7149 39.5023 -29.438 -28.7732 26.1015 +3886 4 51.6029 27.7352 38.6212 16.0201 9.86215 -30.6452 +3887 4 51.6337 28.456 39.976 12.6328 17.4546 7.30145 +3888 6 34.2938 28.319 17.2582 8.1769 -6.30709 4.0332 +3889 4 33.5147 28.7567 16.9609 -27.2201 13.5182 -7.119 +3890 4 34.2215 28.3851 18.2119 5.48963 -10.3892 10.8325 +3891 6 36.9125 8.03614 37.8626 31.6258 41.6511 37.5008 +3892 4 37.1772 8.64874 37.1722 -6.23292 -16.4311 -22.0997 +3893 4 37.3691 8.52088 38.6203 -30.9712 -36.3395 -15.9768 +3894 6 34.8794 19.4073 6.12479 12.5531 6.66298 1.29528 +3895 4 34.0931 18.8687 6.15723 -9.84615 -2.81902 0.903663 +3896 4 34.5874 20.3343 6.07707 7.75337 -1.04832 -3.72421 +3897 6 52.9388 9.46792 7.82791 49.0384 32.8563 -49.3294 +3898 4 52.8922 10.1625 7.06425 -6.6048 -31.3865 41.9454 +3899 4 52.145 9.34409 8.30569 -37.6802 7.72308 13.142 +3900 6 36.3078 5.4787 38.9756 -59.3492 -35.3574 -23.3076 +3901 4 36.7604 5.44249 39.7856 34.2456 7.44664 27.0781 +3902 4 36.4713 6.28646 38.5283 19.3627 32.146 -13.2298 +3903 6 10.0102 14.4476 13.47 7.45507 32.9986 11.9551 +3904 4 10.2267 15.3574 13.7991 -6.33005 -21.0964 -5.42394 +3905 4 9.26267 14.5991 12.8847 -7.70629 -5.78085 -0.713961 +3906 6 17.2158 24.3617 39.7859 1.82925 -26.4802 17.5225 +3907 4 16.9252 25.2477 39.6578 -10.2532 23.1813 -8.78866 +3908 4 16.8659 24.1409 40.6742 12.3143 -2.49802 -8.33055 +3909 6 49.0708 32.5605 7.76617 4.98775 -19.9892 12.4117 +3910 4 48.2488 33.0406 7.85919 -4.66971 4.38963 1.84033 +3911 4 49.5854 32.9586 7.08254 9.03816 10.9607 -18.1455 +3912 6 44.8772 24.3958 5.47001 55.4245 15.4507 -4.26518 +3913 4 44.8128 24.5742 6.41303 -16.1158 -0.171295 7.10823 +3914 4 44.0866 23.9971 5.17679 -42.0653 -18.1716 -4.3799 +3915 6 37.3106 29.1913 32.8596 13.2918 -7.82588 25.4298 +3916 4 36.7195 29.353 33.61 10.148 2.43022 -0.346483 +3917 4 36.7915 29.3572 32.1043 -27.5405 3.64351 -29.7293 +3918 6 0.903259 24.8209 21.2384 21.1637 23.8586 -12.5999 +3919 4 1.07153 25.1845 20.3306 -6.36458 -4.90686 24.2304 +3920 4 1.48599 25.3539 21.839 -15.2813 -16.355 -7.82064 +3921 6 53.0335 2.20305 13.0061 -8.76459 0.917863 -30.1717 +3922 4 52.7178 1.83592 13.8181 -1.16689 -4.66991 20.3458 +3923 4 53.3973 3.07458 13.1779 4.70755 1.41814 13.7418 +3924 6 24.3073 33.9788 13.9425 26.9643 -19.8352 3.53447 +3925 4 23.8166 33.1535 14.1304 2.48225 11.7572 -2.64876 +3926 4 25.2622 33.8278 14.204 -36.1259 9.29052 -3.07765 +3927 6 40.931 19.3008 0.314297 -22.2267 40.7784 4.53314 +3928 4 41.073 18.3876 0.266006 15.5735 -49.6404 -1.39225 +3929 4 41.7685 19.7545 0.415523 11.1161 2.19254 -0.550631 +3930 6 38.3131 32.0321 21.5909 -11.558 27.6654 -12.3629 +3931 4 37.7152 31.3901 21.181 3.54948 -0.803384 -4.61225 +3932 4 38.0485 32.9451 21.2634 6.02672 -33.9485 15.0266 +3933 6 42.3093 34.9988 16.9782 -31.0886 21.3467 -4.04435 +3934 4 41.4322 34.9872 17.4259 23.1708 5.16072 -1.2535 +3935 4 42.7209 34.172 17.1456 10.0707 -23.8474 2.85212 +3936 6 19.5555 24.3301 21.9337 4.81064 -45.312 41.7565 +3937 4 19.0503 23.5208 22.2695 18.6897 32.4519 -16.5084 +3938 4 18.9494 24.7901 21.383 -21.2783 9.24005 -16.3011 +3939 6 21.0765 3.08453 14.9497 18.8565 6.62045 0.482113 +3940 4 21.9827 3.42458 15.1377 -20.4059 -2.71097 -2.70114 +3941 4 21.0593 2.94323 13.9894 -7.00518 -5.35814 1.95693 +3942 6 16.4422 12.1477 28.531 -0.750899 4.00912 3.87665 +3943 4 16.9503 12.6102 29.2147 -1.62139 -0.392447 -5.94721 +3944 4 15.8278 12.7952 28.1633 1.40376 -4.03425 1.22377 +3945 6 29.5501 4.7113 21.752 31.6763 -19.7408 -11.7502 +3946 4 29.7575 3.81476 21.3864 -8.62397 20.1371 9.94028 +3947 4 28.6767 4.97136 21.4837 -14.307 1.15287 -5.34284 +3948 6 47.4015 12.0887 13.4082 -20.234 -20.0739 19.2385 +3949 4 46.7896 12.1748 12.658 5.24956 2.33261 8.08179 +3950 4 46.8763 11.6307 14.143 25.8489 23.9178 -32.3489 +3951 6 26.4368 0.034911 5.58657 -64.7941 -10.5287 17.818 +3952 4 25.4579 0.386547 5.64311 57.7785 -5.53424 -8.5606 +3953 4 26.2825 41.0177 5.90114 11.1228 18.2746 -10.9356 +3954 6 20.8239 34.8091 41.3451 3.02448 22.7042 23.7072 +3955 4 20.8848 35.7307 41.7064 -1.83719 -23.2001 -12.5561 +3956 4 21.5135 34.3024 41.8142 -0.435548 5.34794 -5.15218 +3957 6 12.6914 17.4806 1.38079 -1.22179 11.8948 19.0955 +3958 4 12.6924 17.2614 2.32235 1.20892 0.120609 -3.36771 +3959 4 12.6119 16.652 0.923905 -0.609755 -13.5185 -16.0456 +3960 6 30.0783 10.198 8.41195 2.12134 -1.25171 -25.3141 +3961 4 29.3533 10.7626 8.0964 5.01977 -3.23694 0.534487 +3962 4 29.9182 10.0601 9.33268 -3.94599 -2.47727 24.1034 +3963 6 36.3506 5.44781 23.9083 -0.549638 14.3818 20.7021 +3964 4 36.0156 6.32048 23.6328 6.62881 -2.58855 0.476976 +3965 4 37.0027 5.63115 24.6267 -8.58297 -8.41851 -13.9364 +3966 6 34.0301 39.9488 19.4964 -23.0399 -20.8249 18.5921 +3967 4 34.456 39.4415 20.2152 6.93565 15.6495 -14.2212 +3968 4 34.6348 40.5483 19.0534 11.5364 2.12704 2.14354 +3969 6 25.0981 29.0133 17.0022 63.4673 53.603 -24.6749 +3970 4 24.4066 28.4545 17.2066 -49.3728 -47.1307 14.2315 +3971 4 24.9323 29.3693 16.11 -4.01222 -10.2038 10.3173 +3972 6 28.4991 21.3215 6.5284 30.3134 51.3135 12.4116 +3973 4 28.073 21.8131 5.82363 -12.0684 -17.0718 -17.6117 +3974 4 29.0439 22.0969 6.88435 -18.1485 -38.7813 5.23359 +3975 6 18.6639 26.1486 0.434559 17.278 41.4043 -10.2832 +3976 4 18.2934 25.3073 0.618971 -26.4426 -25.2614 5.85754 +3977 4 18.1648 26.8598 0.892557 2.28699 -17.4047 3.2853 +3978 6 10.9881 29.7025 15.4563 -76.0882 18.6105 19.9394 +3979 4 11.66 29.3744 14.945 58.6215 -25.2203 -34.7363 +3980 4 11.3165 30.0451 16.2682 18.0847 5.23212 20.5617 +3981 6 33.4842 3.75768 10.5858 0.636803 10.5574 28.6939 +3982 4 33.4734 3.50079 11.5612 -0.522502 1.02567 -36.066 +3983 4 33.5593 4.73652 10.6 -0.068286 -14.4363 0.33475 +3984 6 12.2823 28.8038 23.0281 11.3775 -6.29424 6.84391 +3985 4 12.7596 29.6284 22.9364 3.04418 8.52871 -1.54448 +3986 4 11.6562 28.9633 23.7417 -11.9653 1.92572 -6.97409 +3987 6 13.0879 10.2853 41.0171 -47.2786 6.02767 7.69694 +3988 4 13.8008 10.0588 41.5617 38.8858 -12.6991 24.323 +3989 4 13.445 10.533 40.1929 12.5253 9.31307 -31.237 +3990 6 45.8279 29.9763 22.3517 -19.0059 -47.3471 -0.794771 +3991 4 46.3385 30.6632 22.7121 22.9496 35.5749 11.5915 +3992 4 46.1736 29.1608 22.8005 -10.4716 15.4455 -15.9284 +3993 6 41.5587 12.1258 14.79 16.8952 2.46742 -19.497 +3994 4 40.8127 12.0778 15.3866 -8.88903 2.06539 11.4921 +3995 4 41.9001 13.025 14.8368 0.886253 5.83282 4.44761 +3996 6 18.1774 7.21532 24.17 -10.7079 71.0597 15.5191 +3997 4 17.3895 7.85304 24.2309 32.278 -29.8877 -8.26822 +3998 4 17.8432 6.3671 24.0218 -31.5603 -50.1252 -1.23769 +3999 6 1.46617 28.3087 7.5822 17.4051 32.8243 -18.4272 +4000 4 0.972435 27.5241 7.77639 -23.983 -7.56132 -3.64975 +4001 4 0.919057 29.0368 7.16413 8.17263 -22.6878 11.3207 +4002 6 11.3257 12.3178 24.0505 6.50608 36.5044 21.7543 +4003 4 11.787 12.9182 24.6663 -15.142 9.53056 -9.69028 +4004 4 11.7144 11.5384 24.3755 9.90684 -45.3393 2.97811 +4005 6 17.9727 40.4585 24.4268 -2.1753 13.4943 43.6914 +4006 4 18.2079 40.9973 23.706 15.3173 17.1897 -35.5256 +4007 4 17.8423 41.1404 25.131 2.16294 -27.9915 -10.5346 +4008 6 25.5983 7.44259 34.0136 19.3716 5.77393 -21.6373 +4009 4 25.8935 7.97324 33.2232 -7.88236 -13.8451 20.6491 +4010 4 24.6626 7.5793 34.1612 -12.3217 5.75259 0.6842 +4011 6 16.9533 36.3934 7.79695 -14.7733 -58.972 -15.2131 +4012 4 16.1509 35.7821 7.92089 32.5681 38.8119 0.0631702 +4013 4 16.873 37.2333 8.21975 -10.866 19.0251 14.3825 +4014 6 12.4478 39.1676 36.8063 -58.2746 -19.2691 -7.14825 +4015 4 13.2621 39.5728 37.0444 24.763 -2.90148 -1.94315 +4016 4 12.5678 38.2718 36.42 14.2903 21.5885 11.3364 +4017 6 23.4428 1.91286 37.7232 -9.22102 6.32267 -24.8838 +4018 4 22.7837 1.60923 37.0782 3.11058 2.78987 13.6287 +4019 4 23.6923 2.7833 37.361 6.97145 -2.92816 9.87668 +4020 6 26.6131 34.8527 39.0629 -0.358317 22.46 -5.08852 +4021 4 25.9211 35.0251 39.7209 4.63868 -0.642547 -8.45736 +4022 4 26.6245 35.623 38.4346 -11.8568 -25.3624 13.8384 +4023 6 44.7506 35.5772 23.1679 10.7298 -18.8811 -26.4233 +4024 4 44.6498 36.2622 23.8111 -7.39072 22.4611 10.5052 +4025 4 44.899 35.9413 22.2637 -2.27133 -5.1907 16.9936 +4026 6 34.6136 35.4178 26.71 -15.9342 1.46423 13.2724 +4027 4 33.7739 35.201 27.1682 15.3038 9.13482 -13.5788 +4028 4 35.2424 35.4667 27.4557 -1.55634 5.60609 -12.3698 +4029 6 12.4253 29.8367 9.37257 6.8074 7.71813 14.8361 +4030 4 12.5954 30.1793 10.279 -1.64518 -2.79843 -17.3301 +4031 4 11.9756 30.5342 8.87466 -2.55144 0.413422 5.70549 +4032 6 46.4578 41.3781 16.9525 -1.71223 -15.9012 -6.63524 +4033 4 46.309 0.164546 17.5847 2.66821 13.6546 8.2853 +4034 4 46.3887 41.8168 16.0911 -0.805017 -2.71613 2.08401 +4035 6 39.1753 31.0467 24.0118 -3.10819 6.08124 -21.6124 +4036 4 39.1065 31.2708 23.0301 -7.23524 -5.82233 36.9271 +4037 4 38.2867 31.0608 24.4123 9.52041 3.88051 -10.8568 +4038 6 40.5402 9.7597 28.9847 14.8037 -28.2595 -25.194 +4039 4 40.7176 8.78836 28.9335 -4.00485 22.4893 3.39032 +4040 4 39.9733 9.89103 29.7293 -9.65138 5.58475 19.0645 +4041 6 33.5593 11.9211 22.729 -1.15717 -3.69298 36.7387 +4042 4 33.4631 12.1387 21.8005 -14.8881 8.7456 -3.74916 +4043 4 32.9393 12.4796 23.2922 26.8098 -15.4098 -27.756 +4044 6 29.0159 38.7519 2.46278 27.6721 -15.5988 -40.3681 +4045 4 29.1586 39.6546 2.1748 2.74048 3.67355 2.54153 +4046 4 28.5501 38.8453 3.26351 -22.211 -0.421087 25.3577 +4047 6 51.2833 6.14739 28.3043 6.24107 -1.78447 -16.8419 +4048 4 51.6927 5.30788 28.0231 -4.79213 3.01935 13.8596 +4049 4 51.5671 6.73798 27.5888 -1.89698 -2.53529 10.4249 +4050 6 34.1064 16.6123 14.042 -37.0155 -16.4066 -7.07731 +4051 4 33.9904 17.5439 13.9588 -10.6946 23.5239 -0.125603 +4052 4 35.0244 16.4872 14.0391 48.662 -2.86898 -0.118382 +4053 6 34.4321 40.0645 7.48859 13.9518 5.57425 38.6209 +4054 4 34.6497 40.8416 6.93548 -15.3832 -25.9537 -5.407 +4055 4 34.0868 39.3056 7.01264 2.49953 7.17747 -18.8692 +4056 6 42.5297 22.9808 4.38266 2.56422 12.7755 -29.8183 +4057 4 42.7079 23.1404 3.43503 2.07895 -8.20356 9.72626 +4058 4 41.6007 23.2438 4.43282 3.68115 -1.88729 13.9368 +4059 6 1.41725 11.7089 10.583 40.9585 72.4956 7.82458 +4060 4 2.29602 11.7947 10.1149 -31.3121 -19.1762 2.07637 +4061 4 1.32217 12.6809 10.8959 0.250133 -47.8987 -12.0904 +4062 6 10.0222 17.1523 40.4009 -13.9984 -42.4532 23.0969 +4063 4 9.09922 16.7881 40.4362 25.3227 17.9847 -3.64852 +4064 4 10.5566 16.4623 40.9043 -11.7978 28.1532 -20.1855 +4065 6 26.3773 1.16785 23.7951 0.897687 17.1036 -20.4546 +4066 4 26.2949 1.59753 22.8926 6.72339 -10.2637 31.134 +4067 4 26.8106 1.83522 24.3632 0.404944 -5.36666 -8.232 +4068 6 4.47728 16.2319 39.0174 38.9165 -19.7518 -18.3291 +4069 4 4.60126 15.8787 38.0926 -3.95383 11.2541 23.7603 +4070 4 5.37849 16.1152 39.4714 -36.6531 9.54225 -13.0705 +4071 6 24.3645 39.8454 14.0862 11.6717 18.512 -7.42816 +4072 4 24.2179 40.7168 13.6655 -1.51261 -13.0973 5.973 +4073 4 25.144 39.5095 13.6466 2.38152 -7.3908 -1.6645 +4074 6 19.9724 19.004 10.1294 8.87966 -14.5095 2.71373 +4075 4 19.0999 19.3915 10.2782 -1.93643 -3.06257 7.63815 +4076 4 20.1403 18.2899 10.8137 -9.49435 28.7308 -18.8504 +4077 6 45.2455 15.0555 25.2985 9.44949 25.5865 29.6023 +4078 4 44.5225 15.6147 25.6238 -9.11717 -2.3226 -13.4673 +4079 4 44.9162 14.4027 24.6993 -17.0358 -18.2103 -14.0354 +4080 6 47.6513 32.9537 29.9733 -3.02769 -8.48031 15.1317 +4081 4 47.7848 32.4488 30.7976 5.01558 10.2706 -8.76515 +4082 4 46.6987 33.0693 29.9097 -5.02316 -0.316015 -4.02449 +4083 6 9.31033 14.1561 35.6305 -9.15199 13.4931 14.7277 +4084 4 10.2186 13.9515 35.3646 1.69372 -1.68405 10.862 +4085 4 9.25805 14.5533 36.5394 11.2175 -11.577 -22.5615 +4086 6 0.560208 28.7354 32.128 -23.2584 38.0618 20.8665 +4087 4 0.439761 29.1616 31.2639 2.79308 -8.58991 0.800302 +4088 4 0.67028 27.8063 31.9961 10.5465 -16.7679 -9.91325 +4089 6 26.1282 14.1993 40.8411 59.6454 -38.6249 5.43898 +4090 4 26.432 13.4524 41.4491 -20.3805 31.5142 -12.0858 +4091 4 25.201 14.2926 40.8644 -35.6636 2.31432 7.08225 +4092 6 38.0409 1.72795 37.3461 -15.986 9.3487 3.27435 +4093 4 38.337 1.77003 36.4219 -6.4212 0.733726 8.60438 +4094 4 37.1869 2.24333 37.3721 25.3175 -16.9011 -0.126137 +4095 6 43.391 21.0055 0.385428 11.1435 51.3868 10.1231 +4096 4 43.3728 21.9356 0.739051 -22.7765 -27.5137 5.23027 +4097 4 44.2566 21.1078 41.893 4.66373 -25.0138 -11.6612 +4098 6 29.7339 12.3948 17.084 15.7249 11.0657 13.1734 +4099 4 30.3928 12.9555 17.5239 -4.04604 16.1495 -27.1654 +4100 4 29.6387 11.801 17.8166 -19.321 -23.8097 4.84602 +4101 6 21.0831 10.9976 35.6454 20.8751 25.9078 26.8503 +4102 4 20.9144 11.9356 35.5 -2.5465 -0.914036 2.40284 +4103 4 20.6111 10.5739 34.9651 -17.7649 -25.2648 -31.6786 +4104 6 24.3635 22.1336 17.0651 -49.7832 5.03398 -16.9936 +4105 4 24.7447 22.8357 16.5516 14.0354 11.6369 -2.31656 +4106 4 25.0369 21.6158 17.4366 35.7007 -17.2122 18.4164 +4107 6 44.2543 9.63808 6.15039 20.313 -11.2139 14.5913 +4108 4 44.7688 9.46356 5.36091 -1.47318 -0.699349 -10.0319 +4109 4 43.371 9.9028 5.92157 -14.9065 6.10764 -5.2575 +4110 6 40.8032 2.87739 6.28666 -13.1289 22.479 10.901 +4111 4 40.3272 3.11809 7.09229 2.74106 -9.45257 -1.64817 +4112 4 40.5645 3.60702 5.69531 8.12536 -6.41414 -12.3146 +4113 6 23.4888 29.7691 25.1996 -20.8577 -7.3866 7.78845 +4114 4 23.0356 30.0691 24.4173 -11.1707 -5.96106 -7.76576 +4115 4 24.1981 30.3761 25.2406 38.2449 14.7306 0.541559 +4116 6 45.2336 20.6129 7.48752 -14.5833 -17.9538 -3.88696 +4117 4 44.4222 20.5961 6.94177 10.1673 3.83834 -0.615812 +4118 4 45.4226 19.6724 7.65027 4.1577 11.2609 0.378107 +4119 6 44.1804 26.5848 16.646 -7.77871 8.0927 60.0057 +4120 4 44.4497 26.5291 15.7549 9.82788 -17.3929 -39.3829 +4121 4 43.995 25.6977 17.0036 0.668911 -2.30329 -14.751 +4122 6 23.5902 27.0659 18.0913 -39.7013 -11.93 7.95298 +4123 4 23.083 26.2674 17.8176 19.208 11.4009 -9.44785 +4124 4 22.9184 27.4761 18.6801 25.6051 0.00742342 -8.40738 +4125 6 45.1467 16.0991 8.91755 -25.3782 -1.90264 -8.59791 +4126 4 44.1891 15.9425 8.7462 16.1978 6.4454 1.17339 +4127 4 45.2138 16.0078 9.87006 7.52298 -2.6657 10.2407 +4128 6 39.0203 15.1531 5.23259 28.6956 12.0263 -26.8074 +4129 4 39.7994 15.5772 4.7964 -10.087 -12.1112 6.39319 +4130 4 38.3368 15.7917 5.08662 -19.5574 10.6606 0.980846 +4131 6 40.468 4.77411 20.0927 -27.3359 -4.798 12.1592 +4132 4 41.2634 4.72652 19.6 29.6653 -1.38796 -18.2664 +4133 4 40.7147 5.23292 20.8909 -0.487482 4.30709 11.6637 +4134 6 35.8395 28.4372 39.9091 -50.8572 -25.335 -8.14583 +4135 4 35.0416 27.8127 39.7761 37.8149 25.8469 12.2999 +4136 4 36.4241 28.1912 39.1903 12.774 -11.5781 0.139918 +4137 6 26.5706 3.57143 2.67715 -46.9093 11.529 -12.2012 +4138 4 26.01 3.47498 1.86726 21.0232 -0.263485 19.1529 +4139 4 25.9795 4.13239 3.25499 25.5536 -16.3527 -3.3314 +4140 6 2.96374 21.6426 17.6806 -14.2306 -5.51577 -4.68338 +4141 4 2.93927 22.2072 18.4518 0.989431 6.72084 9.51867 +4142 4 3.70489 21.9005 17.1296 5.59779 10.8847 0.849605 +4143 6 12.8869 25.0552 25.9401 15.4127 26.4598 -14.83 +4144 4 13.2774 25.9118 25.6194 -5.06291 -21.1213 8.866 +4145 4 12.0842 24.9634 25.4247 -11.7493 -3.09829 -2.0396 +4146 6 41.5869 20.6707 14.1801 -22.4147 -6.05744 0.611169 +4147 4 42.2929 20.1295 13.8255 12.8925 2.43785 -7.39699 +4148 4 41.9118 21.5622 14.3536 8.70683 -8.7017 2.36606 +4149 6 1.26372 39.5934 11.5416 -2.31472 -23.2994 -17.666 +4150 4 1.60499 38.7626 11.0579 -12.721 36.8399 30.164 +4151 4 1.30151 39.4907 12.5143 8.15813 -4.07121 -11.1907 +4152 6 16.0274 39.0089 34.0759 -23.376 3.35378 -54.2756 +4153 4 15.5279 38.2654 33.6809 12.2329 5.59336 21.1278 +4154 4 15.9645 39.6681 33.3256 8.94624 -4.65522 31.8649 +4155 6 20.5749 7.01511 25.5545 -9.93748 22.9073 -1.77669 +4156 4 20.7998 7.9126 25.2373 7.69672 -13.5438 0.480138 +4157 4 19.6147 7.02086 25.4453 1.79337 -5.45304 -5.32881 +4158 6 45.1903 25.5946 39.1745 -26.3826 2.10768 23.1727 +4159 4 45.9078 26.0337 38.7511 23.0136 15.7961 -19.2282 +4160 4 45.315 24.6755 38.9972 4.74877 -22.0383 -3.82349 +4161 6 19.9254 40.1108 28.2935 0.936604 13.13 -6.83142 +4162 4 19.0415 40.3022 27.9603 -1.00367 -13.9734 -0.221352 +4163 4 20.1058 40.9072 28.8104 6.81084 -8.28794 7.10232 +4164 6 26.5025 14.2024 27.3816 7.55525 -11.5245 -39.7478 +4165 4 25.5661 14.1885 27.2241 -23.3405 -0.187867 -1.3667 +4166 4 26.5864 14.6167 28.2174 4.05242 7.69107 36.9512 +4167 6 51.349 25.9455 3.44193 13.1564 1.83251 -14.1309 +4168 4 51.0731 25.276 4.04973 -8.84751 -13.2679 15.0063 +4169 4 51.8098 25.4164 2.75525 -2.9574 19.5765 2.79729 +4170 6 20.1579 26.1269 2.66057 8.08543 -14.232 12.5138 +4171 4 20.4198 25.2285 2.95049 1.99012 13.1431 -7.88687 +4172 4 19.9848 26.1042 1.70984 -1.68704 0.137755 2.48294 +4173 6 3.12857 11.9594 27.2244 18.8731 20.7243 14.7894 +4174 4 2.60719 12.6622 26.8077 5.30838 -2.59233 -3.81502 +4175 4 3.76928 12.4285 27.8301 -19.9135 -11.7573 -12.7739 +4176 6 30.1745 26.3671 4.00755 44.117 -33.7612 35.926 +4177 4 30.7719 25.91 3.40695 8.20711 -11.5121 5.52432 +4178 4 29.6741 26.8182 3.4039 -49.0538 48.0497 -39.0484 +4179 6 19.309 20.6617 30.5327 -6.17305 20.3286 19.7257 +4180 4 19.3357 21.5037 31.0044 -16.2324 -1.53368 2.5841 +4181 4 20.215 20.6027 30.2783 24.1248 -10.9268 -16.9107 +4182 6 13.5428 36.2605 0.333332 15.0011 -10.6689 28.2547 +4183 4 13.9636 37.1467 0.274336 -13.564 -9.3403 -16.0521 +4184 4 12.8146 36.0991 41.6409 -4.77188 14.7057 -15.3617 +4185 6 13.69 21.7667 35.9665 -20.2473 -15.4187 -13.4538 +4186 4 13.4364 21.3658 35.099 7.7487 10.4825 13.8843 +4187 4 14.5406 22.1631 35.8296 17.4857 6.37333 -3.13554 +4188 6 39.4374 1.76506 25.3393 -36.4427 -7.29022 -10.5984 +4189 4 39.9364 2.34528 25.9215 16.7605 -3.08023 1.72977 +4190 4 39.8192 0.8892 25.1573 19.013 15.1682 11.727 +4191 6 18.3049 6.14326 35.8392 -10.8025 -19.5812 3.54688 +4192 4 18.125 5.32611 36.3393 4.50778 0.182671 -16.8727 +4193 4 18.2664 6.78418 36.55 10.3297 13.4079 -7.40032 +4194 6 2.50698 24.635 10.1008 2.82606 57.1639 14.1456 +4195 4 3.34783 24.2504 10.0645 38.9609 -42.7111 -6.9151 +4196 4 2.85647 25.509 10.4424 -34.1939 -15.4438 -5.60802 +4197 6 35.8245 9.94707 1.36321 12.392 22.5458 6.51215 +4198 4 36.2598 10.3662 0.602857 -1.03193 -1.33218 7.37913 +4199 4 36.14 10.4815 2.15194 -8.91958 -29.9524 -28.0328 +4200 6 29.0093 17.9332 41.5934 -7.9582 -11.0366 0.585828 +4201 4 28.5465 17.2289 41.1281 -16.7755 -3.81322 9.83818 +4202 4 29.6221 18.1453 40.9114 24.9254 25.1746 -10.164 +4203 6 46.0106 27.0842 25.8657 -15.8538 -10.6571 1.20957 +4204 4 46.7573 26.8966 26.4316 13.3887 1.52966 8.34957 +4205 4 45.3967 26.3449 26.0537 1.02353 6.85943 -7.5889 +4206 6 28.1115 10.6516 35.9124 -31.4415 -9.81676 -35.067 +4207 4 27.3321 11.0804 35.4953 10.9044 -14.8673 0.927998 +4208 4 28.4149 11.3158 36.4913 19.5717 24.3857 28.0975 +4209 6 25.9462 20.1874 24.7713 21.0981 19.7274 8.06252 +4210 4 26.7479 20.7296 24.6265 -12.3387 -9.71047 -3.27099 +4211 4 25.8934 20.1715 25.7373 -11.4252 -1.9185 3.65337 +4212 6 32.2315 30.2636 10.2038 46.2181 -42.2335 3.06511 +4213 4 32.6954 30.7903 9.55855 -13.4496 21.2522 -10.6663 +4214 4 32.9512 29.5744 10.3289 -28.7668 14.232 9.31608 +4215 6 5.05112 34.4033 23.8133 19.5013 -14.7597 17.0713 +4216 4 5.8904 34.9145 23.8209 -18.4686 -4.57798 -7.44977 +4217 4 4.4328 34.8283 23.2333 -4.78059 12.4432 -11.9709 +4218 6 29.6287 34.9421 23.1129 15.2461 20.4143 1.29823 +4219 4 30.2662 35.203 23.7945 -9.70178 1.77141 2.28452 +4220 4 29.7307 34.0083 23.0447 -4.13429 -24.1479 2.03513 +4221 6 52.1909 25.2296 36.2512 2.86438 -10.6824 22.6831 +4222 4 51.9483 25.3775 37.2028 5.23419 -4.07811 -26.4725 +4223 4 52.3343 24.2634 36.1804 -4.32722 6.81431 1.64545 +4224 6 6.96184 41.26 14.9825 2.80521 -5.8094 -40.534 +4225 4 7.04984 41.0874 15.8994 5.94782 -9.0625 22.8431 +4226 4 7.58542 40.6644 14.4953 -8.6815 16.2518 18.3581 +4227 6 27.6618 39.1341 4.65497 -15.321 -2.42325 19.5764 +4228 4 26.8583 38.6531 4.9607 13.8024 7.31782 -7.34321 +4229 4 28.2878 39.16 5.39008 -5.06496 -7.53921 2.22048 +4230 6 44.4448 15.8874 30.3939 -2.31018 0.103575 -22.4191 +4231 4 43.6353 16.4379 30.2788 15.6665 -12.4266 1.42045 +4232 4 44.7559 15.574 29.5018 -16.8402 11.4423 19.721 +4233 6 27.2939 38.1254 13.0955 15.3768 -40.6351 2.35664 +4234 4 27.6299 37.3572 12.5713 -6.06373 15.2601 5.99839 +4235 4 27.2975 37.7701 14.0147 -10.0522 11.5876 -10.9657 +4236 6 26.6773 32.9794 36.8294 -32.6396 -25.4624 12.1292 +4237 4 27.3491 33.5429 36.5103 30.2383 22.5556 -9.12925 +4238 4 26.1784 33.4868 37.4729 2.39424 7.35453 7.52648 +4239 6 26.3034 28.2003 31.7109 71.1077 16.3155 0.283388 +4240 4 26.8193 28.3341 30.863 -27.929 -6.55919 23.3278 +4241 4 26.9955 28.4613 32.4053 -35.143 -9.24619 -18.2719 +4242 6 49.2075 35.7729 23.3324 -21.4287 30.6035 9.89313 +4243 4 49.7648 36.3085 23.9054 5.92838 -6.84736 -0.0129328 +4244 4 49.7125 35.0813 22.9401 23.5965 -22.3057 -11.2126 +4245 6 44.2384 15.3735 33.5479 -0.546939 -12.4927 -0.897907 +4246 4 44.8734 15.133 32.8785 13.8917 -2.34347 -2.72297 +4247 4 43.5631 15.8174 33.0372 -7.79828 14.1806 -0.143619 +4248 6 16.6415 35.2629 14.0425 -13.711 -12.7272 -22.5016 +4249 4 16.8779 36.1297 14.3524 2.35153 17.3801 14.4176 +4250 4 15.7232 35.3535 13.695 18.4875 1.24889 7.88518 +4251 6 45.2979 21.4768 12.0753 -61.6802 -17.7786 9.36854 +4252 4 45.9745 21.1118 11.5746 47.2025 -15.5682 -31.9287 +4253 4 44.6407 20.7302 12.0307 13.4445 30.1014 15.4365 +4254 6 51.647 5.33893 20.0992 17.3373 6.85256 40.4731 +4255 4 51.8423 5.82757 20.9547 -12.0569 -16.4938 -26.4666 +4256 4 50.8652 5.75336 19.736 -8.70547 10.2387 -6.49138 +4257 6 22.616 27.3068 0.953729 -12.5585 5.72419 11.7926 +4258 4 21.9912 27.9206 1.39427 2.62886 -13.0847 -9.82719 +4259 4 22.9744 27.8285 0.229956 6.91293 3.08187 -2.36887 +4260 6 46.8924 12.1405 22.3241 28.0037 10.4006 6.07885 +4261 4 46.5361 12.6234 21.5839 -13.5229 3.11861 -11.9828 +4262 4 46.2058 11.655 22.757 -25.8682 -9.85748 8.02404 +4263 6 33.7577 5.61095 25.2306 8.81298 -10.6825 9.18366 +4264 4 34.4045 5.06092 24.7535 -5.77276 6.31779 -0.0821136 +4265 4 33.06 5.8369 24.6155 -4.37455 2.20678 -7.03208 +4266 6 44.2424 18.1337 27.2287 35.5912 4.17402 -1.61274 +4267 4 44.1428 18.6708 26.4104 -1.15401 -3.8952 20.8354 +4268 4 45.2041 18.2132 27.495 -32.4507 -0.562547 -10.2772 +4269 6 5.27745 36.9951 29.0779 -48.9341 45.2857 -18.2185 +4270 4 4.83797 37.847 28.7 19.7525 -41.2711 21.6555 +4271 4 6.18662 37.2124 29.1987 31.023 4.60304 7.81739 +4272 6 20.0415 5.02171 38.9415 13.5567 -45.1901 -20.6947 +4273 4 19.673 5.46942 39.6755 -5.65499 20.9205 26.8401 +4274 4 20.3443 4.13258 39.2728 -11.021 23.424 -4.53385 +4275 6 17.9077 2.77821 33.872 -28.7289 7.66476 22.1934 +4276 4 18.5675 3.36618 33.4993 11.2764 5.36232 -3.32863 +4277 4 17.289 3.30252 34.4687 25.3234 -20.0176 -17.8345 +4278 6 5.56252 23.3664 22.3199 23.4646 34.0494 22.6536 +4279 4 6.31266 23.4141 21.6995 -10.6272 -11.1368 -5.13028 +4280 4 5.83055 24.0852 22.9498 -18.4748 -15.0058 -11.9197 +4281 6 12.7366 28.0136 40.0786 16.9267 17.0007 -14.1953 +4282 4 12.7736 28.981 40.2539 2.04889 -13.1204 -10.7842 +4283 4 13.1752 27.8683 39.2015 -12.0592 5.90979 20.7524 +4284 6 50.5208 38.8121 28.4283 -2.96204 -29.3557 2.62021 +4285 4 51.1161 39.4306 28.008 -0.383593 20.3423 -2.32338 +4286 4 49.7133 39.2143 28.7877 7.69194 10.1621 -6.76025 +4287 6 33.551 8.21903 17.8634 -36.1599 -47.4859 45.2019 +4288 4 33.9333 8.85376 17.3385 32.2471 57.3944 -47.1321 +4289 4 33.8604 7.38657 17.5128 5.83122 -9.97324 -0.737685 +4290 6 34.648 34.7105 17.7828 9.01761 -19.7832 -8.77749 +4291 4 35.1788 35.3328 18.2888 -3.00831 8.66808 4.62333 +4292 4 35.2883 34.0014 17.5711 -12.5093 2.94991 -0.39307 +4293 6 40.7261 5.27864 23.3991 8.21105 0.19251 11.4926 +4294 4 41.4259 4.93717 23.9966 -11.2767 2.88733 -17.4667 +4295 4 40.0598 4.58084 23.2941 1.87831 5.06613 5.43463 +4296 6 16.9137 27.769 14.4809 73.6258 -34.7175 -8.82476 +4297 4 16.0667 28.1115 14.4612 -62.8462 32.6704 -2.60496 +4298 4 17.5486 28.5101 14.4313 -15.9271 -1.25076 7.8547 +4299 6 29.0219 14.6595 5.00786 20.8741 -13.5443 13.1138 +4300 4 29.536 13.8229 4.89138 -12.0375 16.0826 3.98067 +4301 4 28.8859 14.7576 5.97494 -2.91261 0.0620574 -16.4413 +4302 6 36.854 17.7325 5.08016 4.48522 -18.3735 -43.8449 +4303 4 36.2168 18.3553 5.39001 -11.7806 18.6728 17.0618 +4304 4 36.8305 17.8608 4.09391 11.7548 -5.76061 25.8999 +4305 6 27.7142 25.5094 34.8662 20.7401 -29.3529 -12.6468 +4306 4 28.3997 25.1535 35.4786 -13.7878 13.2187 -9.69645 +4307 4 27.3728 26.292 35.2699 -5.77421 14.8272 18.3022 +4308 6 24.7481 17.2805 18.0642 -3.31447 -10.4308 -2.46491 +4309 4 25.3087 17.9154 18.5049 2.27957 10.048 8.00722 +4310 4 24.0564 17.0505 18.7104 4.01172 4.3516 -6.8818 +4311 6 30.1789 1.58441 5.83411 4.12275 19.8646 -71.4749 +4312 4 29.4821 1.85802 6.42075 -6.9839 1.28517 8.89789 +4313 4 29.959 2.0434 4.91278 6.77151 -29.6581 61.3265 +4314 6 37.452 25.891 8.43789 -40.1641 -31.4732 50.6902 +4315 4 38.334 25.9927 8.78667 20.6785 -4.95116 -4.15592 +4316 4 36.9881 25.2791 9.14634 19.6253 32.8331 -49.0064 +4317 6 24.7604 7.00734 2.27008 32.0581 9.85747 -12.4546 +4318 4 25.4028 6.31463 2.48931 -5.40489 7.62931 7.6933 +4319 4 23.9158 6.58667 2.26874 -21.5893 -3.78057 4.11792 +4320 6 25.7887 38.8506 10.7619 -30.5475 28.1992 -59.3139 +4321 4 26.3103 38.4194 11.381 38.5207 -12.4255 48.7922 +4322 4 26.1525 39.7259 10.4932 -1.18865 -9.03037 15.3914 +4323 6 0.555207 13.578 28.1388 12.6332 42.7054 11.738 +4324 4 0.341766 12.7807 27.7179 -10.1825 -36.9478 -16.4943 +4325 4 0.413626 13.4435 29.0864 -5.17296 -1.28815 -2.85065 +4326 6 20.4105 17.1191 12.037 -17.9302 -38.4569 -26.5492 +4327 4 20.2295 17.2547 12.9605 -1.34068 5.07474 20.9983 +4328 4 19.8884 16.3005 11.7926 16.4515 20.0565 4.33162 +4329 6 30.9925 7.37797 16.6653 29.7996 22.3073 3.61878 +4330 4 31.2643 7.03844 15.7784 -2.63758 10.9944 17.123 +4331 4 31.7569 7.94595 17.0261 -27.6116 -29.8279 -14.8225 +4332 6 10.2093 5.78517 12.1714 32.5037 6.96704 58.397 +4333 4 10.1014 6.35617 11.4591 -8.08786 32.1119 -50.7901 +4334 4 9.65707 5.06197 12.024 -36.7963 -41.1043 -15.4671 +4335 6 18.4347 31.3493 24.155 3.48135 -6.25246 2.65688 +4336 4 18.4439 30.3878 24.2879 -2.95335 1.71216 0.944019 +4337 4 18.3198 31.7316 25.0273 -3.67252 2.09543 1.27238 +4338 6 27.8948 29.2525 29.2666 2.33504 21.8021 -21.5937 +4339 4 28.3627 29.5914 28.4251 -11.9103 -18.4763 37.4515 +4340 4 28.5196 28.9609 29.9463 14.9294 0.890267 -8.6061 +4341 6 38.3738 15.4456 29.791 12.9945 -28.6313 15.0543 +4342 4 38.0891 14.5036 30.0544 22.1369 39.5396 -7.74746 +4343 4 39.2957 15.632 30.1541 -37.4531 -3.97597 -10.3113 +4344 6 21.7041 34.7992 5.56934 -10.1436 -56.1371 25.2208 +4345 4 21.4621 33.8673 5.89439 16.7439 32.0975 -19.9868 +4346 4 20.9431 35.2741 5.907 -2.46203 13.3807 -4.97838 +4347 6 18.2064 16.8274 1.01093 1.02147 5.09087 9.91972 +4348 4 17.6405 17.264 0.353478 -0.489627 -6.58546 6.49815 +4349 4 17.8529 17.0628 1.89865 0.517006 0.361128 -13.8735 +4350 6 43.5166 18.4972 39.3436 16.5286 13.9247 -42.0759 +4351 4 43.0101 19.1966 39.7112 -21.9319 15.1254 24.622 +4352 4 43.7095 18.933 38.4597 1.00685 -29.3013 20.2287 +4353 6 17.7976 10.0688 35.5434 7.86102 19.599 -20.2005 +4354 4 17.8945 9.40709 36.2105 4.74187 -18.2058 11.3424 +4355 4 18.5459 9.97323 34.9151 -16.2901 -5.18221 9.2364 +4356 6 36.5889 30.5599 29.0828 -33.0481 48.6405 -12.465 +4357 4 36.5132 31.4977 28.7143 1.54088 -37.0728 8.50934 +4358 4 37.4982 30.324 28.9756 25.7485 -11.7594 -3.68806 +4359 6 38.4943 35.9682 10.4222 10.3079 16.2999 40.226 +4360 4 38.6552 36.6966 11.1228 -3.33458 -34.9071 -25.8136 +4361 4 38.3509 35.1294 10.9235 4.16648 17.1849 -3.98913 +4362 6 43.4036 18.8037 34.3607 -18.7725 -42.8138 41.3108 +4363 4 42.9709 18.1893 33.7432 11.3097 10.906 -2.86187 +4364 4 43.2777 18.3171 35.2411 6.94038 29.5352 -30.5758 +4365 6 11.0585 40.2128 6.10885 -15.7783 5.94868 1.16987 +4366 4 11.5965 40.9262 6.45194 10.3679 4.26541 4.32644 +4367 4 10.1443 40.5526 6.13585 6.40705 -5.05479 -5.29954 +4368 6 48.3342 13.7493 24.4707 -3.46168 30.4962 28.8754 +4369 4 47.8576 13.3588 23.754 -13.8134 -6.92474 -20.9085 +4370 4 47.8711 14.5963 24.7134 14.7345 -25.1065 -10.1999 +4371 6 1.47205 25.7712 23.7829 0.184952 23.7651 -2.41746 +4372 4 0.854396 26.4618 23.4919 -3.79407 -11.1699 -2.17794 +4373 4 2.13056 26.3319 24.2122 9.67536 -12.9921 7.11562 +4374 6 20.5856 0.045789 21.1048 4.96875 -22.7073 -7.43464 +4375 4 19.8117 0.249922 21.5931 -19.4423 21.7426 16.1957 +4376 4 20.4519 41.001 21.0443 13.8042 -0.350206 -3.82588 +4377 6 37.6675 12.896 30.7055 18.9575 -14.1068 -43.1025 +4378 4 37.1872 12.5493 29.907 3.14127 2.53034 24.3729 +4379 4 37.0391 13.1763 31.3358 -31.377 6.23238 20.3235 +4380 6 49.4665 17.3801 9.24655 -8.32961 25.946 -15.5009 +4381 4 48.5345 17.665 9.32633 16.3924 -11.5392 1.15372 +4382 4 49.8219 17.9883 8.54454 -1.98957 -21.6031 19.5257 +4383 6 34.3643 5.3502 17.1421 32.952 7.78829 -18.2658 +4384 4 34.6245 5.26975 16.1857 -14.4704 2.64329 20.4158 +4385 4 33.4298 5.20109 17.2262 -20.6176 -11.2241 -0.901893 +4386 6 14.7832 27.6655 0.085624 -10.3553 13.8949 -22.792 +4387 4 14.1034 27.8892 41.3249 2.03342 -11.2849 14.5146 +4388 4 15.1757 28.5319 0.287496 2.39463 -6.00136 9.68974 +4389 6 48.8635 15.5211 20.7504 -7.30397 3.37214 15.1279 +4390 4 49.1252 16.3754 20.4371 0.183023 13.7927 -3.76167 +4391 4 49.1585 14.9241 20.0762 3.93917 -17.6947 -14.7742 +4392 6 23.8074 40.3851 20.3877 -2.3041 21.5375 32.1864 +4393 4 23.5266 40.991 21.1382 8.45078 -18.9812 -28.3519 +4394 4 24.6929 40.0818 20.645 -4.8729 5.63426 -4.96266 +4395 6 35.18 31.4993 13.7142 -38.6695 32.0432 -41.3249 +4396 4 34.2219 31.3119 13.4889 30.0091 9.93153 3.95626 +4397 4 35.4367 30.7845 14.243 12.3636 -35.8089 30.5679 +4398 6 10.9775 9.01115 39.5206 -26.3812 35.8658 -19.2594 +4399 4 10.5557 9.91556 39.5205 15.5031 -28.3669 -8.85108 +4400 4 11.1542 8.87096 40.4393 5.31517 -3.54045 10.232 +4401 6 53.2061 4.88103 16.6049 -20.6689 -12.7794 3.6937 +4402 4 53.6782 5.3887 17.2239 33.7717 25.1716 19.5104 +4403 4 52.5676 4.51498 17.2255 -11.3933 -13.1169 -19.2452 +4404 6 7.83562 33.8039 26.1496 42.0062 50.3869 -17.047 +4405 4 7.62463 34.1533 27.0155 -6.33847 -9.39794 9.82588 +4406 4 8.42034 34.5749 25.7852 -30.6961 -50.8642 6.91563 +4407 6 31.3279 27.9472 6.28298 4.37835 -19.3247 -9.6219 +4408 4 31.922 27.5111 6.93657 -10.4846 5.09347 -11.9486 +4409 4 31.1129 27.3323 5.53276 6.79934 9.76999 15.6259 +4410 6 31.3655 2.17383 41.055 18.9421 -1.98994 34.5993 +4411 4 31.8109 2.17902 0.04034 -17.0754 7.04602 -28.7946 +4412 4 31.2404 1.23747 40.9086 -7.00813 -7.80206 -8.22245 +4413 6 33.7652 4.25739 35.9001 -31.2863 -13.3655 20.8802 +4414 4 34.2485 3.80076 36.6104 5.56552 8.36292 -9.80816 +4415 4 32.8077 4.13792 36.1863 30.7439 3.51509 -16.9094 +4416 6 47.9725 16.0636 29.8584 -12.289 -4.0311 -5.35812 +4417 4 48.7208 16.4163 30.3732 -4.13056 -10.8519 0.408936 +4418 4 47.3533 15.5947 30.4559 16.7379 8.85318 -0.563064 +4419 6 49.3385 10.0935 28.5885 -11.8118 4.56009 -13.0989 +4420 4 48.5886 10.6638 28.8239 3.51911 -4.5157 1.44109 +4421 4 49.3924 10.1159 27.6088 6.69909 -1.91925 15.8757 +4422 6 21.4187 27.7693 29.76 2.80336 -20.4787 -6.37736 +4423 4 21.861 27.2354 30.4624 -7.84738 15.6574 -13.8161 +4424 4 21.1828 28.6282 30.0799 2.10219 20.3695 17.9057 +4425 6 11.6757 39.482 25.8517 13.5538 20.9417 -1.29545 +4426 4 12.2965 38.7786 26.0889 -7.12508 -2.9493 -2.05027 +4427 4 10.8193 39.0846 25.7116 -11.9056 -6.20494 0.0112269 +4428 6 22.9798 39.311 7.85817 -12.7601 -4.86939 -3.04246 +4429 4 22.3059 38.6219 7.95844 1.92638 3.98273 0.136758 +4430 4 22.5772 40.0658 8.31757 9.04497 -1.85468 3.82529 +4431 6 42.5415 35.9278 31.3391 13.0935 -70.9729 -20.1514 +4432 4 42.6447 35.4696 30.4714 -5.52665 5.17936 25.8951 +4433 4 42.5102 36.7973 31.0384 -8.93799 60.9387 2.27408 +4434 6 33.663 14.7412 3.98499 30.4225 -17.693 -39.6888 +4435 4 32.8564 15.2185 4.09596 -24.3526 16.5192 2.50389 +4436 4 33.8944 14.7916 3.00116 -11.9532 1.40502 32.6284 +4437 6 36.697 8.6017 17.5153 18.7294 -29.9333 -4.55465 +4438 4 37.1702 7.95911 16.9159 -11.687 24.5338 13.7544 +4439 4 36.2734 9.25409 16.9543 -7.54123 3.80926 -6.08989 +4440 6 20.8295 32.4146 17.3309 -48.7404 -21.5825 11.0081 +4441 4 20.1664 32.9726 16.9048 10.2664 9.72211 -3.82622 +4442 4 20.2271 31.8015 17.8465 35.2036 12.7196 -8.50107 +4443 6 20.7003 35.3218 14.1083 -3.44914 -18.0461 -19.2112 +4444 4 21.3182 35.5386 13.4099 3.08163 2.90557 -13.4495 +4445 4 20.919 35.9437 14.7754 1.56244 13.5022 22.2067 +4446 6 20.2323 2.51936 40.1651 -9.22326 -14.3688 36.1644 +4447 4 19.7926 2.34354 41.0434 13.5524 6.30823 -28.5037 +4448 4 20.7516 1.7186 40.0171 -1.27786 1.50094 -7.75906 +4449 6 15.0477 14.4672 0.24789 12.9865 -5.55034 -72.7807 +4450 4 15.4827 13.6954 41.6877 -12.87 20.0829 29.6139 +4451 4 15.2186 15.2036 41.5094 -2.93016 -13.2387 23.097 +4452 6 24.8149 37.3373 18.5213 2.43631 -2.68492 27.9859 +4453 4 24.4361 37.9203 17.8611 -0.249038 9.91659 1.71419 +4454 4 24.5604 37.6468 19.4234 0.486379 -6.00228 -23.279 +4455 6 3.16989 27.7944 5.24229 1.80682 -16.6913 61.515 +4456 4 2.664 27.92 6.09489 -0.254446 2.50987 -32.3978 +4457 4 4.0252 27.4816 5.63916 -14.135 1.37322 -28.2843 +4458 6 37.1257 39.0598 36.0573 4.58816 40.5807 23.3296 +4459 4 37.5599 39.5885 36.7783 -22.7086 -1.13864 -22.8071 +4460 4 37.5439 38.2379 36.1828 13.5973 -37.3165 -5.96047 +4461 6 41.3477 16.3672 3.84024 25.8131 6.72768 37.2631 +4462 4 41.4431 17.3182 3.89206 -17.3786 8.01961 -13.1803 +4463 4 42.0046 16.1549 4.54461 -14.0821 -19.2698 -21.0799 +4464 6 15.5755 3.1684 35.3585 1.47298 2.70845 -61.2084 +4465 4 15.1145 3.59171 34.5864 10.479 -16.2188 17.3147 +4466 4 15.2032 3.60881 36.0782 -15.9672 22.7619 40.5269 +4467 6 33.1731 24.2438 7.96729 6.41569 -10.7526 14.1331 +4468 4 33.3408 24.6773 7.1445 11.9115 -7.07525 -26.7187 +4469 4 32.5824 24.8707 8.33408 -19.4303 14.6961 21.7816 +4470 6 35.865 29.7374 15.5979 -29.8607 35.3275 -32.1308 +4471 4 36.7747 29.6672 15.7703 43.701 -12.5229 16.5971 +4472 4 35.3562 29.0371 15.9739 2.56537 -15.478 18.0667 +4473 6 17.5843 36.8354 41.8728 12.1708 -5.57123 -52.5088 +4474 4 18.1833 36.773 0.675699 12.2604 -1.93512 36.5948 +4475 4 18.2359 36.8623 41.125 -21.8566 7.06165 11.6698 +4476 6 26.5622 4.14672 31.1307 -32.6289 -51.1506 -31.7953 +4477 4 27.2582 4.59627 31.5457 41.9615 24.0313 17.3243 +4478 4 26.8928 3.23766 30.8727 -4.86114 29.783 15.5489 +4479 6 31.9552 1.33198 34.4369 -14.3248 -8.90334 35.5546 +4480 4 32.7269 1.15305 34.9944 8.32726 6.02564 -17.2377 +4481 4 31.2642 1.08685 35.0838 -0.545778 4.81468 -20.3916 +4482 6 24.491 14.7534 2.38457 33.2042 -23.9469 17.2683 +4483 4 24.2753 13.9637 2.92779 -7.56186 18.0622 -11.5291 +4484 4 25.4626 14.8414 2.55985 -20.2114 8.54272 -9.97318 +4485 6 25.7566 20.9055 27.5389 -1.15091 7.1508 6.95521 +4486 4 25.459 20.6057 28.4261 8.17968 -1.38894 -17.9407 +4487 4 25.6371 21.8685 27.5748 1.97223 -1.15564 -2.97875 +4488 6 18.1445 40.1527 30.6395 17.3729 -20.3781 15.2884 +4489 4 18.5141 39.2638 30.8544 -10.5973 16.1604 -9.36512 +4490 4 18.9393 40.7073 30.6583 -6.94059 7.54086 -5.9327 +4491 6 46.7889 23.8914 24.5979 7.31075 41.4222 -46.8858 +4492 4 46.2898 24.602 24.0741 10.6002 -32.8666 22.2289 +4493 4 47.4121 23.5287 23.9473 -6.99108 -0.957122 4.26591 +4494 6 45.6201 22.6921 26.5067 -14.1777 -10.0967 -12.8229 +4495 4 46.0372 22.9342 25.6668 -2.41585 -1.26552 16.8561 +4496 4 46.0784 23.1676 27.2003 -0.61408 1.28207 1.11474 +4497 6 20.1006 4.48803 26.6974 -40.8522 40.1383 42.8029 +4498 4 20.2489 5.43817 26.4853 8.37449 -26.4011 -0.951475 +4499 4 20.6602 3.93368 26.2205 34.0606 -24.4352 -38.1565 +4500 6 35.278 26.5864 12.552 0.280065 20.4825 10.9931 +4501 4 35.6728 25.7022 12.4634 2.08478 13.3641 8.87461 +4502 4 35.7774 27.1222 13.2104 -5.20465 -19.6779 -15.4464 +4503 6 3.25879 33.9669 12.2907 -5.01808 -25.4739 5.3677 +4504 4 2.34263 33.6224 12.3201 4.20809 12.7539 -0.381501 +4505 4 3.26735 34.9165 12.3326 -4.58918 17.9212 0.78916 +4506 6 36.6873 1.27899 25.5756 -31.8717 2.25298 32.7844 +4507 4 37.6116 1.37326 25.7779 18.4499 5.6721 -4.77344 +4508 4 36.2122 1.51788 26.4163 6.97172 -2.04149 -25.7728 +4509 6 16.8705 4.65685 24.0413 -35.5309 2.76318 -23.9776 +4510 4 15.8575 4.70434 23.9217 47.0687 -0.0954558 1.21401 +4511 4 17.247 4.33879 23.186 -5.50277 -2.28941 17.9023 +4512 6 39.6565 15.0715 7.80572 25.6093 19.6796 32.1194 +4513 4 39.2854 14.2576 8.13712 -9.42359 -13.1845 -9.18942 +4514 4 39.3628 15.2517 6.91527 -5.26665 -12.4192 -5.15573 +4515 6 9.97948 20.1659 2.91877 -9.38613 14.9664 11.2777 +4516 4 9.63877 20.6452 2.15027 4.12295 -11.9706 -3.67253 +4517 4 9.85969 19.2106 2.80597 1.71997 13.0916 -4.74013 +4518 6 23.4135 4.6314 15.2717 1.19087 -47.3757 24.1847 +4519 4 23.6596 4.57091 14.3636 3.27412 12.4021 -25.8415 +4520 4 23.0767 5.481 15.4712 -5.64379 31.4202 -0.243197 +4521 6 23.5143 41.6409 17.9193 15.1077 8.25095 -6.6202 +4522 4 23.8837 41.2632 18.7444 -17.9015 4.85421 -1.14363 +4523 4 22.6477 0.129763 18.1032 2.89941 -5.9973 3.37217 +4524 6 30.9257 4.8197 1.33225 52.4556 82.2644 21.8498 +4525 4 30.6067 4.04082 1.0087 -28.5575 -73.6424 -29.1188 +4526 4 31.8008 4.99709 0.898826 -20.2281 -12.9509 7.44496 +4527 6 29.2107 33.7595 18.6102 73.0072 -21.2941 -2.29721 +4528 4 30.2072 34.0216 18.5444 -47.9733 -6.17517 5.28057 +4529 4 28.7323 34.5281 18.37 -21.0864 31.3556 1.11974 +4530 6 23.1159 16.7161 3.6681 15.0693 -22.2232 4.2808 +4531 4 23.7494 16.3853 2.99745 -15.1451 3.0429 8.25243 +4532 4 23.0882 17.666 3.59926 -2.15966 11.8771 -4.335 +4533 6 34.9011 26.7664 31.7501 -1.76717 8.52767 -40.8429 +4534 4 35.037 27.6398 31.3273 1.29043 -2.59798 26.5044 +4535 4 34.999 26.223 30.9552 -0.698038 -3.54606 8.98008 +4536 6 7.10213 40.7731 20.9713 24.4432 1.2064 -5.23395 +4537 4 6.57619 40.3882 20.2802 -20.054 -4.79313 -9.64846 +4538 4 7.95521 40.8692 20.51 0.818491 4.17448 7.60026 +4539 6 52.4557 9.69054 11.9333 -13.8891 -19.4181 -13.3487 +4540 4 52.1298 8.88818 11.4535 9.48574 25.0976 13.8313 +4541 4 53.1611 10.0725 11.3936 -7.122 -1.8527 1.23238 +4542 6 12.0235 32.7598 27.7442 3.70099 -7.78602 -3.89203 +4543 4 11.3626 32.1501 27.3892 -5.86407 9.3821 3.02313 +4544 4 12.7405 32.6461 27.1218 9.18069 3.19616 2.31322 +4545 6 15.7918 18.546 0.850378 10.8461 -1.95532 -11.5883 +4546 4 16.438 18.9813 1.41668 1.29405 -2.87095 0.147979 +4547 4 14.9753 18.6242 1.3119 -21.1882 -0.0291689 9.92309 +4548 6 30.9967 13.9378 7.42939 11.475 1.61738 -44.5395 +4549 4 31.0432 13.5913 6.48715 -7.7997 1.97415 36.5778 +4550 4 31.6719 14.6391 7.43931 -7.46887 -7.66354 10.6483 +4551 6 23.9383 39.564 3.55488 34.3001 -22.0749 -10.0269 +4552 4 24.3437 38.8163 4.07249 -17.2972 16.8542 -11.2744 +4553 4 24.6493 39.7352 2.88999 -19.8697 7.819 10.5959 +4554 6 53.2452 13.9576 2.00229 -14.7116 -5.90049 -8.44118 +4555 4 54.0493 14.3984 2.24709 19.6807 0.169927 9.22775 +4556 4 52.9645 14.4205 1.20429 2.95034 -7.59818 -1.70329 +4557 6 29.4557 26.4275 7.80964 12.1022 6.02758 -9.79702 +4558 4 29.9353 26.7368 7.00545 -17.6775 -4.91001 19.2628 +4559 4 28.525 26.2807 7.58748 -5.08244 6.84096 -3.37299 +4560 6 24.6247 23.6022 31.0889 -22.8452 23.3962 -39.3716 +4561 4 23.7242 23.1866 30.9343 31.0198 16.8155 5.56769 +4562 4 24.7802 24.3072 30.3632 -7.32447 -41.3429 34.091 +4563 6 33.6649 19.3163 40.5091 -6.65541 -1.27585 7.81728 +4564 4 33.8354 18.657 41.2044 -1.67667 1.74775 -3.87809 +4565 4 34.3105 19.1562 39.8145 2.0445 4.20075 -4.1701 +4566 6 0.559384 35.9874 14.2134 5.8565 -19.6842 -1.82955 +4567 4 1.23941 35.9463 14.8996 -3.202 15.0395 2.84586 +4568 4 0.030681 36.7785 14.2979 -4.01885 14.7851 6.49139 +4569 6 7.05661 12.759 15.7779 -22.8667 -6.52104 17.6379 +4570 4 6.34583 12.5966 16.4564 20.9558 0.33122 -21.552 +4571 4 6.91757 12.0848 15.0954 -2.34629 3.44815 6.08752 +4572 6 7.88282 3.87818 22.4173 5.89555 -44.5054 15.1514 +4573 4 7.49019 4.56914 21.9267 -7.80716 26.896 -25.5563 +4574 4 7.61791 3.03791 21.9647 5.08594 18.6769 15.1101 +4575 6 50.7471 32.0888 16.2401 1.83727 42.1646 -7.06137 +4576 4 49.8752 31.8312 16.5285 -7.29916 -4.21179 -0.512004 +4577 4 50.6362 33.057 15.9791 5.96194 -37.4522 8.78354 +4578 6 15.303 18.2089 30.059 10.7923 -22.0796 25.2673 +4579 4 14.9011 18.5061 29.2675 -14.0638 14.0876 -27.3921 +4580 4 14.9173 17.3208 30.1974 9.34767 8.93092 3.04247 +4581 6 36.7231 25.4597 33.3812 -54.2725 16.2506 -34.9161 +4582 4 35.9173 25.838 32.8237 55.5216 -11.0114 39.6871 +4583 4 36.747 24.5432 33.1027 5.79642 -6.85026 5.14009 +4584 6 16.5358 21.8507 20.2615 -17.2006 3.10996 -10.5852 +4585 4 16.5318 20.9271 19.9881 4.62491 -6.39719 -1.16283 +4586 4 16.2171 22.3466 19.4835 8.40466 -0.269645 8.83911 +4587 6 44.2784 3.11614 30.075 -4.29151 -10.9085 31.9498 +4588 4 44.2908 2.23086 29.7056 -5.3385 -9.83615 -1.81045 +4589 4 44.5205 3.68982 29.3775 9.49019 22.102 -29.428 +4590 6 51.0822 14.1295 27.7742 -18.732 -33.3382 -1.30318 +4591 4 51.215 15.0658 27.7997 -1.99026 24.8352 -0.164216 +4592 4 50.1181 13.9695 27.6298 18.0185 9.91077 0.913588 +4593 6 54.1414 15.8836 27.1251 18.1892 -50.717 -21.9912 +4594 4 54.5758 14.9905 27.2793 -7.90108 34.3346 13.352 +4595 4 53.8259 15.7459 26.2068 -12.5208 17.6482 15.4671 +4596 6 26.7107 15.1629 34.529 26.3006 32.6175 -12.2305 +4597 4 26.7089 16.144 34.4655 -8.86078 -18.0829 7.52702 +4598 4 27.5163 14.9973 34.009 -10.4907 -11.0891 -0.654257 +4599 6 34.6699 2.22267 27.4725 27.1341 -12.2799 29.337 +4600 4 34.3153 1.93716 28.3227 7.08088 3.88889 7.09202 +4601 4 33.8991 2.25298 26.9555 -28.541 9.30381 -28.496 +4602 6 36.3083 17.6409 40.3953 7.68303 1.60807 9.57574 +4603 4 35.716 17.1791 39.8253 -12.5236 -4.37947 -14.4862 +4604 4 36.6569 16.9265 40.9504 1.18426 15.263 2.6664 +4605 6 26.2972 0.194896 33.0957 0.945324 -1.75644 -10.1569 +4606 4 26.0926 0.771392 33.8475 -8.68516 2.0119 1.91424 +4607 4 25.4691 41.6865 32.8295 -8.00507 -1.67316 12.192 +4608 6 5.19113 35.5773 31.6357 23.2413 -27.7984 27.0466 +4609 4 6.1476 35.7159 31.7435 -10.1506 4.22761 6.12862 +4610 4 4.96861 36.095 30.8978 -11.7512 22.2076 -38.0194 +4611 6 20.2191 22.0354 35.1304 9.30742 -6.19625 19.4235 +4612 4 19.9844 21.2003 34.7289 -5.16022 -6.81034 -3.33987 +4613 4 20.4782 21.7596 36.0473 -3.02096 9.85719 -25.9724 +4614 6 15.9251 36.5949 36.947 -9.13121 -30.7472 31.1466 +4615 4 16.4837 37.3712 37.0549 6.13876 -3.03661 -2.05614 +4616 4 16.031 36.0658 37.8159 -5.1453 16.1721 -39.9007 +4617 6 30.9484 22.4015 3.56131 11.993 -60.8988 -15.4947 +4618 4 31.1008 22.6958 4.44557 1.55935 5.74187 27.4751 +4619 4 31.2551 21.4217 3.58407 -13.4398 43.4536 -6.61432 +4620 6 47.0429 8.40936 14.2086 -4.42011 -15.6298 -34.0486 +4621 4 46.2603 8.29509 13.606 17.325 5.05196 18.7602 +4622 4 47.7698 7.89697 13.7682 -18.8904 11.0332 12.0247 +4623 6 34.1011 18.6159 3.148 0.361877 23.965 35.4915 +4624 4 34.6363 18.3397 3.89922 -0.845538 -0.743075 -4.07575 +4625 4 34.3812 18.1265 2.40098 2.04544 -17.9565 -29.3984 +4626 6 26.7996 25.3961 12.3408 -30.8906 -54.2954 26.5725 +4627 4 27.3117 26.1608 12.4557 20.536 44.4803 3.39785 +4628 4 26.6414 25.0259 13.2528 6.28377 9.49183 -30.6151 +4629 6 22.6108 25.7845 30.8845 17.3255 -0.303924 3.7754 +4630 4 23.4288 25.6954 31.4132 -11.344 -1.13015 -1.03332 +4631 4 22.2314 24.9052 30.7722 1.09512 -5.6623 7.4309 +4632 6 23.6311 9.76276 35.7585 -2.90797 -4.19552 -4.78319 +4633 4 22.8314 10.2832 35.6581 -5.74139 5.63622 4.02691 +4634 4 23.3139 8.86685 35.4998 11.2809 19.0625 6.63709 +4635 6 10.4076 36.7742 9.64242 -28.436 -9.9846 9.32351 +4636 4 9.50067 36.3875 9.59353 19.7531 11.7612 -0.53903 +4637 4 10.7226 36.8301 8.7426 3.69205 5.92187 -13.8772 +4638 6 4.00038 32.4265 25.8669 22.0714 10.4661 11.4497 +4639 4 4.38844 32.9375 25.1422 -1.34031 3.54398 1.69886 +4640 4 3.2706 31.9516 25.4996 -17.8371 -17.4963 -10.4987 +4641 6 29.085 26.0296 18.6527 19.273 -47.5776 11.2122 +4642 4 28.2115 26.0231 19.0264 -21.1607 3.13806 -0.423844 +4643 4 29.4632 25.1291 18.9323 -7.10954 42.4601 -14.5827 +4644 6 15.3089 1.3255 27.9792 -24.1234 20.5069 -17.5654 +4645 4 15.0496 0.974163 27.1169 2.04641 -4.01433 11.5068 +4646 4 14.7355 2.12388 28.0804 19.9995 -12.8223 4.08523 +4647 6 48.6106 2.88816 22.9655 -1.26722 3.55247 -0.201848 +4648 4 48.4165 2.02818 22.6182 -14.5439 -12.5884 3.03438 +4649 4 49.5001 2.98572 22.6432 10.4652 10.9023 -5.33271 +4650 6 53.0075 0.36099 19.7296 11.424 -8.43987 -8.95848 +4651 4 52.5965 41.9022 20.5162 -3.41206 4.78179 6.33318 +4652 4 52.3731 0.223553 19.0136 -6.83989 5.16364 0.289704 +4653 6 1.41074 17.5036 17.9462 -15.7932 -16.9445 -5.36496 +4654 4 1.29993 17.3585 17.0019 -2.92928 12.5396 -5.88676 +4655 4 1.38271 16.6004 18.2823 6.65411 -3.00458 14.0519 +4656 6 37.9084 19.0323 37.6056 -38.9323 8.68785 -13.5971 +4657 4 36.9858 18.7285 37.7384 11.3307 8.89304 -0.372118 +4658 4 38.4207 18.4342 38.1195 19.3518 -17.7067 16.118 +4659 6 26.9813 30.3571 38.0896 -0.527767 18.5171 -30.3811 +4660 4 26.1212 30.285 37.6565 1.23907 -9.17466 9.80696 +4661 4 27.2764 31.2069 37.701 2.1524 -13.2267 12.8694 +4662 6 20.0955 18.5722 3.03696 10.9017 21.9571 9.92937 +4663 4 20.0263 17.806 3.59422 -10.4522 -23.2015 2.62566 +4664 4 20.8322 19.0363 3.46766 -4.52129 0.073665 -16.3651 +4665 6 35.0841 6.94694 4.08385 8.40312 -14.6319 10.4582 +4666 4 35.6826 7.16069 3.3578 -1.64356 4.34706 -6.00978 +4667 4 34.2613 7.42764 3.99145 -7.61312 4.93718 -6.31016 +4668 6 22.2176 37.0878 31.2599 -35.8324 13.882 69.7054 +4669 4 22.1593 36.8558 30.3798 -4.04212 -13.8909 -61.3413 +4670 4 21.2552 37.1952 31.5589 44.4461 1.84169 -14.4682 +4671 6 12.3904 22.3711 41.8265 33.9103 21.3816 -17.5574 +4672 4 13.0623 23.0096 41.4404 -31.3175 -17.017 24.3472 +4673 4 11.7392 22.2302 41.1411 -5.71588 1.3909 -0.895108 +4674 6 43.2333 30.3145 23.1566 26.412 30.0652 1.94466 +4675 4 44.1443 29.9954 22.911 -23.9673 11.2944 4.28313 +4676 4 43.3588 31.2906 23.3811 -4.98348 -33.6726 -4.24118 +4677 6 16.5316 8.07904 16.6592 -13.1305 -2.58289 1.30551 +4678 4 16.426 8.46358 15.7881 -7.07274 -4.02537 -8.52635 +4679 4 17.4421 8.27811 16.8595 11.8389 2.77268 11.6749 +4680 6 10.0527 8.64979 31.7837 -8.97334 17.7557 -57.5223 +4681 4 10.1312 7.90747 32.3291 5.58005 -27.1767 37.8097 +4682 4 10.1183 9.47003 32.2578 1.92783 9.29621 23.4619 +4683 6 10.1389 6.52097 25.6279 25.2027 -9.57639 0.964906 +4684 4 9.42987 6.19895 26.1639 -19.2857 -8.54063 7.31181 +4685 4 9.7626 7.17299 25.0306 4.07146 -2.80849 4.96109 +4686 6 49.8614 7.23714 25.5252 -17.9172 7.62946 -5.56104 +4687 4 50.0467 6.31121 25.4422 2.69032 -18.6529 -6.42341 +4688 4 50.6907 7.63095 25.75 18.9978 12.6416 8.6826 +4689 6 18.4677 37.5766 33.9365 -27.5019 7.45217 1.11424 +4690 4 17.6855 38.1606 34.0956 24.1544 -3.52274 -4.16364 +4691 4 18.0518 36.7105 34.0373 4.53854 -5.63623 -1.47673 +4692 6 32.1991 34.7999 39.2511 37.7035 -28.7103 22.0041 +4693 4 32.3976 34.2973 40.087 0.14143 15.1618 -21.7552 +4694 4 31.3182 35.0784 39.3573 -42.2601 10.9481 4.26487 +4695 6 49.5371 23.9083 4.45427 26.1113 1.30104 -36.4507 +4696 4 49.7626 23.2251 5.06121 8.22711 -23.3511 16.8473 +4697 4 48.7895 24.3154 4.8182 -37.5883 23.1909 21.4935 +4698 6 6.05615 24.4755 33.9372 -3.62864 21.1406 1.2609 +4699 4 6.78781 23.8493 33.8811 -5.98028 -5.90455 -1.42734 +4700 4 5.44033 24.2071 34.6424 10.5748 -4.32926 -7.84557 +4701 6 1.71417 22.9797 24.1919 12.9465 25.751 -13.942 +4702 4 1.74027 23.9063 23.8744 -7.21984 -9.04225 7.93975 +4703 4 0.785802 22.7901 24.3299 -10.4675 -5.82386 8.34916 +4704 6 12.4544 16.5695 32.338 -33.1179 2.9171 31.5337 +4705 4 13.1434 15.995 32.5512 52.391 -27.2499 -12.3732 +4706 4 11.9701 16.4097 33.1768 -13.251 25.8897 -21.4653 +4707 6 21.3776 37.3784 27.9508 -6.73969 12.2577 23.3137 +4708 4 21.2203 37.3231 27.0262 1.16773 -1.52428 -34.5533 +4709 4 20.718 38.0458 28.2038 6.71566 -1.73666 8.03222 +4710 6 27.2299 40.8388 28.8031 2.48401 0.937021 1.60569 +4711 4 26.5367 41.5089 28.9565 6.65702 -12.2841 2.86921 +4712 4 27.4065 40.3185 29.6035 -12.9999 8.55112 -0.224288 +4713 6 0.993205 21.7261 13.5372 -53.3037 2.48171 -36.3839 +4714 4 1.86429 21.8093 13.8237 52.7771 -6.56786 29.3883 +4715 4 0.417346 21.4203 14.2472 8.63216 3.11646 10.526 +4716 6 22.3067 2.58146 8.73662 29.448 -13.2509 35.6107 +4717 4 22.9722 3.05705 8.24165 5.16658 9.50374 -8.2335 +4718 4 21.5154 2.5876 8.23764 -24.8297 4.23497 -21.3736 +4719 6 29.9953 17.8456 8.24313 -2.433 8.62767 -9.90081 +4720 4 29.054 17.6713 8.30654 -5.44558 -4.70631 2.21427 +4721 4 30.3746 17.4275 9.01982 5.69521 -3.15286 8.62416 +4722 6 3.62819 37.7118 25.7099 -17.1271 -24.8271 -10.3244 +4723 4 4.40422 37.1524 25.7956 9.9921 4.76654 4.66524 +4724 4 2.941 37.0477 25.4485 4.12723 25.8155 6.09629 +4725 6 26.809 27.648 36.3589 -37.7802 -17.2474 29.8166 +4726 4 26.8014 28.1831 35.5758 -1.13827 16.217 -13.4241 +4727 4 25.8725 27.5642 36.7259 28.3017 7.35189 -21.1707 +4728 6 13.3559 25.3099 38.116 1.93465 -14.8526 16.0582 +4729 4 13.2959 24.3789 38.4372 3.98877 20.6101 -4.99041 +4730 4 14.1146 25.694 38.605 -5.66874 -3.07699 -9.11419 +4731 6 49.7048 27.2599 6.72622 -1.43928 22.3256 -10.7839 +4732 4 49.6686 26.3369 6.45132 -5.99645 4.70457 -4.8273 +4733 4 49.2845 27.8697 6.04945 8.54794 -27.7312 19.0533 +4734 6 39.7449 11.5776 10.1987 6.84991 -8.95817 -1.04181 +4735 4 40.3059 10.8428 9.86803 -8.86198 19.4731 1.33094 +4736 4 39.0907 11.7833 9.50723 6.52335 -1.56097 1.75374 +4737 6 17.4857 24.9907 35.5559 -11.6728 -0.232318 -1.23817 +4738 4 17.2359 24.7743 34.6481 -9.71541 0.96097 3.2925 +4739 4 18.4326 24.9281 35.5495 18.729 -4.76527 0.24637 +4740 6 45.0886 34.9858 31.8393 -13.7853 -2.59791 -12.3576 +4741 4 44.2542 35.4282 32.0247 4.31579 11.0194 10.5125 +4742 4 44.8031 34.4855 31.0733 13.3341 -13.9746 -4.20839 +4743 6 30.2109 9.89077 31.3202 8.39813 20.0527 10.0978 +4744 4 30.4343 10.7522 30.9233 -1.69236 -11.2354 5.34707 +4745 4 30.0976 10.0887 32.2697 2.61193 -8.5831 -6.90929 +4746 6 32.3748 9.22464 6.61109 37.8815 -39.2378 -50.8405 +4747 4 32.2118 8.68084 5.76454 4.57858 20.451 35.1159 +4748 4 31.5433 9.4233 6.96427 -45.6188 15.529 19.6617 +4749 6 9.26845 24.9782 35.9229 1.19564 -9.02769 -15.4958 +4750 4 8.9564 25.4582 35.1216 5.49795 -4.99978 19.1154 +4751 4 9.87718 25.5584 36.4061 -8.42028 -2.10732 -11.5846 +4752 6 40.3335 1.48296 18.8902 20.9136 0.652934 -58.3414 +4753 4 39.6207 1.94237 19.2768 -32.228 11.5513 31.9135 +4754 4 40.836 0.952532 19.4949 5.43911 -12.9068 21.333 +4755 6 5.27733 10.6166 30.4293 -4.37857 29.6514 35.8012 +4756 4 5.00531 11.4476 30.0112 -0.880507 -1.63534 -8.13264 +4757 4 5.35863 10.9185 31.3957 -0.759826 -20.4729 -25.7258 +4758 6 25.6655 11.6994 25.6535 -15.8411 -39.3949 6.40341 +4759 4 25.8392 12.448 26.1908 9.94197 23.9877 11.5846 +4760 4 25.8146 10.9427 26.2759 4.01869 23.17 -23.7809 +4761 6 21.9208 20.0736 29.783 -0.661059 -23.1285 25.9828 +4762 4 22.5528 19.9674 30.5279 -9.0028 12.6586 -11.845 +4763 4 21.4796 19.2024 29.7633 3.30396 8.80601 -15.8778 +4764 6 10.0031 19.9894 34.5062 10.0701 -18.9504 -1.84201 +4765 4 9.43917 20.4787 35.093 -9.85162 7.82768 6.06887 +4766 4 9.97528 19.0642 34.823 3.96148 11.1077 -9.79004 +4767 6 24.6395 10.3611 12.2013 10.4056 19.7725 40.7349 +4768 4 24.7062 9.53294 12.699 -2.91134 1.50973 -12.3578 +4769 4 25.0089 11.0108 12.8733 -15.5791 -20.8054 -25.2752 +4770 6 50.4386 28.2959 11.551 52.3964 -11.4141 -41.8896 +4771 4 51.2944 28.7096 11.1811 -37.3824 -15.4271 20.8858 +4772 4 50.1484 28.8694 12.238 -9.02874 19.1251 18.783 +4773 6 13.9255 27.6321 25.0575 -30.7043 9.27758 -16.9407 +4774 4 13.4685 27.961 25.8505 6.53671 1.50814 -8.33226 +4775 4 13.405 28.0084 24.2853 19.6442 -13.6277 24.9436 +4776 6 46.1675 18.6723 40.4127 -24.7255 0.52235 -5.51451 +4777 4 45.2163 18.6287 40.1471 17.8616 -3.70574 0.193046 +4778 4 46.2526 19.5549 40.792 -2.63441 -2.56699 -8.45512 +4779 6 32.4875 14.1744 27.1342 -20.1773 -0.115465 -0.458595 +4780 4 31.894 13.6021 27.6676 10.0212 10.5514 -7.27374 +4781 4 32.1329 15.0809 27.2203 4.74838 -8.22403 2.71507 +4782 6 14.0641 36.351 13.3878 -9.69625 43.6715 -7.48797 +4783 4 14.0645 37.3444 13.3555 12.262 -25.9465 20.9036 +4784 4 13.2835 36.2347 12.8457 -5.28255 -22.0231 -7.64651 +4785 6 1.89477 36.5899 21.9857 -12.7075 -7.68583 0.53673 +4786 4 1.75133 36.5712 22.9388 2.01013 -3.06644 8.01032 +4787 4 2.81569 36.8315 21.8421 3.36212 -1.19737 0.805445 +4788 6 25.2943 31.8607 39.7417 -2.48011 0.614033 34.0265 +4789 4 24.999 32.7283 39.4716 -5.73903 6.77443 -6.35095 +4790 4 25.461 31.9431 40.7124 0.191009 -4.33082 -23.8473 +4791 6 6.4797 22.0186 1.29894 -12.0535 -14.7769 -6.17691 +4792 4 5.53353 21.8063 1.36197 11.0348 5.26157 5.70773 +4793 4 6.5732 22.8347 0.80957 1.58971 11.8894 0.78955 +4794 6 27.6266 25.0275 4.69979 7.76412 30.8855 29.066 +4795 4 28.5017 25.4862 4.66738 -16.9061 -15.4428 -5.02391 +4796 4 27.2115 25.3905 5.52919 8.95609 -10.8934 -21.2922 +4797 6 21.6474 30.9429 41.2213 -14.674 16.9935 -31.5335 +4798 4 21.3077 30.3434 41.8509 -10.7705 -24.5884 29.0962 +4799 4 20.9035 30.9616 40.5667 22.5963 5.39714 5.21952 +4800 6 32.3503 18.8691 12.7728 -7.52429 -0.383917 -18.241 +4801 4 31.3918 18.9773 12.8161 6.27066 1.36054 6.85895 +4802 4 32.4619 18.5656 11.8564 12.6246 0.663961 8.91714 +4803 6 35.6352 19.4593 21.1461 -10.1734 29.4522 17.7801 +4804 4 35.3511 18.62 21.5049 -2.07097 -11.6796 -4.30053 +4805 4 34.9906 20.1214 21.5255 16.9121 -20.2959 -15.2058 +4806 6 27.6974 17.9478 34.0105 3.72497 22.7808 11.4532 +4807 4 28.1244 18.3695 33.2449 -3.6365 -3.33971 3.70746 +4808 4 28.0134 18.5196 34.7467 -3.33496 -14.4526 -11.1074 +4809 6 34.1722 39.0415 14.8025 -0.588556 -5.09353 50.87 +4810 4 33.8492 38.3378 14.2426 -9.69809 -4.78927 -2.35124 +4811 4 33.6075 39.0103 15.6476 14.9636 10.6202 -38.8415 +4812 6 28.5063 3.47722 33.8826 -13.8698 -21.2799 4.06498 +4813 4 27.871 4.20321 33.9085 6.20243 8.28698 -1.91661 +4814 4 29.4175 3.76621 33.9059 10.9167 16.0273 -3.84391 +4815 6 34.9231 32.1486 6.55347 -48.5451 -22.9266 3.43697 +4816 4 33.9921 31.9748 6.9467 49.872 11.9331 -17.2337 +4817 4 35.5478 32.1135 7.28146 1.17984 3.66225 6.53991 +4818 6 31.8923 6.87344 23.517 2.73099 13.3553 4.48118 +4819 4 32.4005 6.72509 22.7097 -0.163961 -9.68163 3.8586 +4820 4 32.2042 7.75277 23.812 -2.19309 -5.80853 -1.60196 +4821 6 18.8495 1.74691 0.846251 -10.8424 6.73855 -33.2301 +4822 4 18.128 2.12906 0.287715 7.30697 -5.37966 19.0723 +4823 4 19.1812 2.42034 1.43504 -3.90896 9.02122 12.2654 +4824 6 27.0029 18.9235 11.8738 61.7268 20.0146 -35.0636 +4825 4 27.2277 19.7644 11.4142 7.64396 -16.2258 9.71345 +4826 4 26.1059 19.0334 11.9849 -72.3018 -1.47246 20.779 +4827 6 43.8315 11.1413 18.4425 12.0955 7.77381 31.2403 +4828 4 43.582 10.9955 17.5403 1.6883 -14.8273 -19.2234 +4829 4 44.4878 10.475 18.7348 -4.89818 7.49251 -15.5557 +4830 6 33.4942 40.5585 37.6724 7.87983 -3.11064 16.6213 +4831 4 33.9456 40.2455 38.4765 5.57637 6.44045 -9.71494 +4832 4 32.6057 40.2384 37.8499 -11.5443 1.61602 -9.31227 +4833 6 15.6218 26.7049 39.4143 -33.8245 -53.4627 11.7102 +4834 4 15.4245 26.9754 40.2985 -0.693124 5.44593 20.3253 +4835 4 16.1216 27.3809 39.0562 36.6223 43.7441 -31.7418 +4836 6 4.38199 13.876 40.8778 6.07973 -11.0772 -3.70535 +4837 4 5.33347 13.6897 41.0138 -14.6737 -0.272428 -1.39073 +4838 4 4.02273 13.2235 40.2449 7.64869 11.7946 8.98025 +4839 6 20.1779 10.396 38.2135 -21.4206 4.43784 1.78325 +4840 4 20.3564 10.9148 37.4134 10.9013 -11.3706 0.559506 +4841 4 20.991 10.2443 38.6984 6.99273 1.77474 -1.94206 +4842 6 15.1578 19.2491 23.8705 6.70925 0.197906 -4.49513 +4843 4 15.3523 20.1614 24.134 -1.79925 -4.44488 8.10361 +4844 4 15.0598 19.3463 22.9079 -1.20619 -5.61783 14.9214 +4845 6 47.881 28.6148 15.8048 16.8356 22.7469 11.8397 +4846 4 48.0602 27.74 15.4965 -2.52866 -23.0751 -5.40804 +4847 4 48.6281 28.8091 16.402 -10.5906 -5.01786 -6.93826 +4848 6 29.925 30.905 18.9707 11.7406 3.33263 -1.10353 +4849 4 29.0879 30.4807 18.764 -8.84985 -7.33813 -1.92291 +4850 4 29.807 31.8375 18.7873 -6.04184 4.11832 2.37084 +4851 6 11.9324 35.8064 28.512 -27.4265 24.0258 -21.7564 +4852 4 12.5706 36.1347 29.1334 15.2736 -4.81493 21.8335 +4853 4 12.2236 34.9831 28.145 8.79196 -20.6768 -0.490374 +4854 6 29.967 37.8624 25.4885 4.59009 -4.14727 -0.313094 +4855 4 30.2605 37.0012 25.8228 -4.78695 -0.224547 -14.1967 +4856 4 30.4431 38.4647 26.0537 0.190265 15.5785 7.27405 +4857 6 52.6385 28.1101 32.2696 27.4129 -14.0906 14.429 +4858 4 52.1837 28.8064 31.8018 1.35463 13.918 -3.63194 +4859 4 53.5572 28.4115 32.4361 -8.8806 -0.527566 -10.0859 +4860 6 37.0194 40.0856 11.9811 12.8522 -14.0915 -8.99985 +4861 4 36.2698 40.6335 12.1547 -20.3135 9.86443 5.11387 +4862 4 37.3206 39.8255 12.8594 7.06858 1.59634 4.17732 +4863 6 16.6823 16.7862 36.5016 -40.0159 24.4695 -22.7659 +4864 4 15.9639 17.4464 36.7433 30.1481 -22.6997 -3.51596 +4865 4 16.709 16.8774 35.5181 2.88256 -1.64708 20.873 +4866 6 28.0056 4.17661 38.8341 -15.1907 4.44859 15.1459 +4867 4 28.8664 4.34511 39.2253 10.7528 -1.70638 -4.98709 +4868 4 28.1362 3.72531 37.9969 -2.54795 -6.06729 -7.91519 +4869 6 28.9121 0.2613 17.7196 11.2429 43.6022 -6.13696 +4870 4 28.206 0.913023 17.5432 1.57334 -10.0134 0.986336 +4871 4 28.5175 41.3357 17.883 -22.7122 -29.353 3.51833 +4872 6 22.9275 20.1119 26.272 10.3141 -17.1908 1.54721 +4873 4 23.597 20.0083 26.9758 -6.33812 5.26805 -6.32666 +4874 4 22.343 20.8217 26.5441 4.5912 8.26641 6.04785 +4875 6 49.4104 29.8887 13.4211 -27.0365 40.5227 7.20695 +4876 4 49.0994 30.824 13.2506 14.963 -27.7355 -0.582388 +4877 4 48.6865 29.5209 13.9525 8.18699 -4.12202 2.86767 +4878 6 2.45827 24.8307 7.29137 -22.8365 1.45709 37.207 +4879 4 2.32025 24.5445 8.23446 11.0976 11.5137 -22.649 +4880 4 1.77037 25.516 7.1857 7.09177 -11.7652 -6.70138 +4881 6 30.3948 26.4611 14.3404 -21.8067 20.3233 2.80707 +4882 4 31.1122 26.3224 14.9982 -12.4575 10.0222 -1.69757 +4883 4 29.8137 27.2743 14.5309 34.7851 -33.9666 2.2264 +4884 6 27.0321 32.5068 3.14827 -14.3662 17.1598 1.60641 +4885 4 26.4039 33.1156 3.62616 22.1531 -16.0826 -13.2832 +4886 4 27.3831 31.9163 3.82559 -1.71579 -4.01879 3.19031 +4887 6 34.2634 14.7959 1.27313 2.99828 -7.05923 -10.0889 +4888 4 35.1835 14.4352 1.19997 -20.4533 4.23129 -4.55267 +4889 4 33.713 14.3258 0.588346 24.9828 8.52884 21.9593 +4890 6 30.022 8.54163 1.32868 -10.2939 -13.069 16.6852 +4891 4 30.0052 9.45247 1.0409 -5.08902 11.4157 2.73646 +4892 4 29.2496 8.43498 1.92915 15.9692 5.13326 -10.6744 +4893 6 42.5647 11.5185 27.7103 -4.68909 6.08661 -3.61857 +4894 4 42.216 12.3928 27.8946 9.09127 8.642 -2.18095 +4895 4 41.8714 10.9656 28.0604 -6.00702 -16.6262 4.78299 +4896 6 52.461 39.5492 17.8365 12.2605 -26.0754 -32.0817 +4897 4 51.7553 39.7908 18.3861 -39.7898 9.50592 28.6027 +4898 4 53.1226 40.1801 18.0155 30.5873 23.5517 5.0779 +4899 6 33.2136 4.91918 31.6183 -6.56942 36.6821 16.923 +4900 4 32.9061 5.86322 31.5606 3.78329 -26.1329 5.01225 +4901 4 32.8884 4.48208 30.835 -2.61462 -3.20134 -11.4125 +4902 6 6.2936 16 18.7476 -12.5252 7.31014 22.9936 +4903 4 5.79227 16.5246 19.4216 24.8679 -4.64947 -16.2991 +4904 4 5.64136 15.3462 18.514 -6.08951 -9.62478 -9.34051 +4905 6 8.52033 14.5365 24.6875 -9.84601 3.26611 -2.01077 +4906 4 9.36791 14.3624 25.0978 6.86066 0.30113 1.47813 +4907 4 8.18366 13.6846 24.3866 1.77672 -1.96336 3.84573 +4908 6 22.6911 10.1297 32.1351 -27.5214 -52.5729 10.3709 +4909 4 22.3884 10.9899 32.3649 2.47289 32.4289 -2.22619 +4910 4 23.5203 10.1223 31.6812 20.4751 21.0076 -14.9216 +4911 6 11.292 2.12704 14.679 -26.9964 -14.1635 0.457424 +4912 4 10.3004 2.01295 14.5746 25.662 7.6895 -7.09692 +4913 4 11.7079 2.38272 13.8392 -0.157448 -3.91762 -7.39795 +4914 6 44.9096 15.591 36.2717 33.6405 -1.91298 -30.8875 +4915 4 45.0764 15.4828 35.303 -3.33411 7.1012 27.4883 +4916 4 43.99 15.446 36.3379 -31.2371 -2.78707 10.2167 +4917 6 9.72465 19.0179 31.2227 19.6005 -24.8416 -16.8371 +4918 4 10.5897 19.4265 31.3159 1.30764 -1.40065 3.11778 +4919 4 9.11252 19.5759 31.653 -23.8989 17.913 16.8503 +4920 6 51.9714 7.58847 16.6881 21.0297 -20.8952 -55.8985 +4921 4 52.6598 6.90966 16.567 -10.1825 8.15334 22.1112 +4922 4 51.6538 7.5728 15.7392 -8.87714 21.5211 34.751 +4923 6 31.4317 34.7753 36.422 -0.942044 -9.40807 -31.2122 +4924 4 31.7249 34.7672 37.3268 6.30465 10.9632 14.3566 +4925 4 31.2441 35.6593 36.0754 6.17504 10.5044 11.3925 +4926 6 4.22663 15.0937 15.3657 -12.9272 -11.1361 22.285 +4927 4 4.10058 14.8824 16.3208 1.18356 5.05287 -17.269 +4928 4 5.17453 15.1773 15.2713 12.4851 5.61025 -4.39011 +4929 6 47.7531 20.6767 28.0224 11.2198 -3.02063 -12.9376 +4930 4 47.6925 19.771 27.6598 -2.10862 13.919 9.51432 +4931 4 48.3916 21.1163 27.4231 -12.1395 -0.81062 10.3277 +4932 6 15.815 1.15165 24.4078 -58.142 17.9603 -16.0616 +4933 4 15.2825 0.557615 24.9446 12.6892 -15.3828 1.22604 +4934 4 15.0545 1.63036 23.9524 41.7436 -8.72437 9.7488 +4935 6 34.5811 39.7067 40.0776 25.1973 35.6425 -42.1699 +4936 4 34.2041 40.3093 40.7031 -18.6223 -6.05265 24.4589 +4937 4 34.3171 38.8242 40.1905 -21.7766 -38.3424 16.3885 +4938 6 20.1959 32.1778 34.4064 -21.1308 28.8301 22.4919 +4939 4 19.7756 32.8897 35.0113 13.9702 -37.934 -23.8567 +4940 4 21.1121 32.1056 34.6926 -2.59197 2.17732 9.39736 +4941 6 19.2966 38.5284 11.8437 26.0429 16.0259 -0.414132 +4942 4 19.2747 37.5954 11.9891 -3.91225 -17.7096 3.53088 +4943 4 20.0654 38.8356 12.3915 -17.5462 -2.40166 -9.14392 +4944 6 6.53181 13.5016 26.8314 -26.032 48.4544 -13.2533 +4945 4 5.96734 14.0602 26.204 31.1233 -23.713 24.7575 +4946 4 6.50803 12.6321 26.4707 -0.853216 -24.803 -10.5103 +4947 6 23.5899 31.5666 33.3383 5.98922 -6.50638 -9.93577 +4948 4 23.0479 31.6137 34.1308 1.15429 -4.79335 1.92272 +4949 4 23.6428 30.629 33.0606 -7.31668 7.17491 0.194963 +4950 6 41.0566 31.9249 16.2102 56.5158 -30.8904 -22.4873 +4951 4 41.9283 32.0344 16.659 -25.525 5.07155 -0.752829 +4952 4 41.3339 31.2779 15.4895 -19.0587 21.5349 12.1439 +4953 6 31.7523 18.8667 19.3593 3.35741 25.414 0.712525 +4954 4 32.0759 19.7269 19.7383 -8.81617 -22.0304 -12.3923 +4955 4 31.2718 18.4298 20.0739 7.05067 -2.94537 3.38628 +4956 6 10.4941 4.11052 19.3414 6.42456 29.4713 -33.6332 +4957 4 9.72315 4.57262 18.9428 7.32966 -14.5804 7.11 +4958 4 11.2095 4.33965 18.6811 -15.5987 -11.1936 33.5314 +4959 6 1.36933 32.4682 19.2841 21.0988 -14.4161 24.2075 +4960 4 2.01529 31.7231 19.2122 -13.2253 9.85044 -10.2965 +4961 4 1.01532 32.721 18.4367 5.36339 -4.1954 -20.4987 +4962 6 42.8687 16.8583 24.9978 45.6636 -43.4462 -50.5941 +4963 4 42.5079 17.7172 24.9824 -17.3855 32.283 0.331695 +4964 4 43.4322 16.7911 24.1362 -30.0172 8.55702 44.8961 +4965 6 45.317 19.181 4.10785 3.8422 34.8536 -4.15721 +4966 4 46.019 19.8398 3.89275 -2.03222 -14.2005 10.5278 +4967 4 44.6424 19.7199 4.5744 3.59127 -10.0852 -3.22755 +4968 6 29.1417 19.8939 35.7514 6.11075 -32.58 -16.2332 +4969 4 28.6926 20.3067 36.4515 -23.9686 13.1333 31.3988 +4970 4 29.2427 20.5957 35.1143 7.28783 5.32225 -12.4577 +4971 6 31.9564 21.8498 19.6592 2.82401 14.2352 -0.350828 +4972 4 32.7548 21.9543 19.0677 -31.5105 -7.28354 24.2009 +4973 4 31.6217 22.7614 19.848 10.5207 -20.3739 -6.13763 +4974 6 39.1981 8.2717 18.8284 -32.9061 14.1933 0.428726 +4975 4 38.9624 7.35629 18.6463 1.07118 -6.83808 -1.96228 +4976 4 38.3348 8.76709 18.6863 31.0345 -14.9445 1.78619 +4977 6 33.2818 13.2775 41.2684 -13.2208 -33.3764 1.31987 +4978 4 32.393 13.5626 41.0006 -3.83673 2.91025 7.56978 +4979 4 33.1808 12.3338 41.5845 5.22215 22.8712 -2.04361 +4980 6 5.9413 29.5498 35.797 -32.456 -34.3071 -6.72563 +4981 4 6.35963 30.284 36.1739 22.861 33.0715 10.0739 +4982 4 6.49565 29.1835 35.1072 8.32337 2.91553 -5.44074 +4983 6 13.0321 34.2086 31.915 -24.835 -40.2345 36.8573 +4984 4 13.0272 33.4084 31.376 1.88868 -0.760633 -7.07942 +4985 4 12.5489 33.9041 32.737 18.271 18.5714 -18.1292 +4986 6 33.9591 21.7903 18.011 18.8454 -21.734 -8.71067 +4987 4 34.7458 21.1933 18.012 -16.5142 3.18134 2.17277 +4988 4 34.2934 22.6573 17.8484 16.983 20.6817 -10.003 +4989 6 35.9748 41.3385 18.1559 -11.3515 0.0380054 -35.3696 +4990 4 35.8093 41.5204 17.1769 9.12346 -12.4659 34.6458 +4991 4 36.6045 0.098617 18.3947 7.40652 10.177 5.52403 +4992 6 34.8515 37.6574 30.5934 11.7527 -35.7483 27.3047 +4993 4 35.1492 36.8608 30.1169 2.57906 15.2804 -10.7791 +4994 4 34.9371 37.33 31.5271 -8.43612 19.6249 -16.9201 +4995 6 26.002 34.4146 4.67279 -8.48904 3.78898 9.19231 +4996 4 25.4415 34.5852 5.42871 -16.9308 -4.98482 2.97274 +4997 4 26.7915 34.86 4.9592 18.7282 4.65341 -5.76761 +4998 6 19.0552 33.5605 1.32358 6.49267 31.5074 -37.6332 +4999 4 19.8139 33.1288 1.70335 8.38847 -12.1483 9.88993 +5000 4 19.4402 34.1326 0.589952 -11.7405 -21.1797 25.0755 +5001 6 25.2648 8.23393 8.59155 9.31521 -3.65292 19.8467 +5002 4 25.4875 8.13778 9.5404 -3.07709 1.08931 -10.3145 +5003 4 25.4314 9.16241 8.38927 -1.28134 -0.00667841 -6.07783 +5004 6 12.8479 19.6935 13.0483 24.3757 5.37981 -4.8091 +5005 4 11.9603 19.9957 12.9501 -28.6845 1.86907 1.18076 +5006 4 13.3523 20.516 12.8959 -4.89806 -16.374 -0.906345 +5007 6 53.3502 11.4299 5.80806 17.1624 -7.42289 17.7098 +5008 4 53.8461 12.0471 6.36061 9.49207 -4.93163 0.0376 +5009 4 52.6392 11.9481 5.49246 -25.6427 10.4986 -14.7278 +5010 6 9.84876 16.0411 31.2026 18.9205 20.8399 7.27663 +5011 4 9.06508 15.7062 30.7868 -18.8641 -2.54228 -13.3824 +5012 4 9.84527 17.0253 31.1624 -7.05614 -14.0763 0.861631 +5013 6 25.427 20.2931 3.30062 11.4464 23.222 26.9187 +5014 4 25.5454 20.7694 4.15249 -9.33169 -17.4988 -10.5652 +5015 4 25.6323 21.0333 2.7154 -3.32412 -15.1122 -12.6987 +5016 6 20.7611 8.20749 15.6389 12.285 -44.7943 -30.6071 +5017 4 20.4521 8.55687 16.4556 -20.4937 3.03897 24.5457 +5018 4 20.4185 7.27697 15.5079 3.31214 29.403 13.2982 +5019 6 37.6491 8.60321 9.97383 13.4411 2.14626 39.4708 +5020 4 37.9762 7.71523 10.2023 -7.3296 7.95364 -3.74733 +5021 4 37.281 8.55077 9.10696 -2.37522 -5.79058 -16.8845 +5022 6 50.6587 4.51935 24.2622 -13.5896 -19.0591 8.29097 +5023 4 49.9232 3.87067 24.2726 8.09814 12.5004 -4.89174 +5024 4 51.4381 3.99879 24.4754 4.23299 2.4676 7.18675 +5025 6 20.1738 24.8175 34.9087 -20.6162 39.8894 -22.5586 +5026 4 19.8889 25.4664 34.1955 11.6566 -19.5752 19.2833 +5027 4 20.4138 24.0094 34.4666 -0.241841 -16.354 -5.00311 +5028 6 30.5812 22.5243 11.2258 -36.8716 21.596 38.6978 +5029 4 31.1688 21.9929 10.7494 35.9784 -15.9007 -22.5785 +5030 4 31.0799 23.2498 11.6175 0.71333 3.79074 -7.65826 +5031 6 17.3246 40.781 8.03002 -31.7256 21.6985 11.3561 +5032 4 17.3609 40.073 8.69249 8.70624 -3.14378 -12.3263 +5033 4 18.1517 40.9293 7.58873 21.0517 -16.9909 -7.06703 +5034 6 23.9551 41.0422 26.0635 49.9815 4.82526 35.6353 +5035 4 24.3667 40.5978 25.3173 -4.54613 -3.84774 -13.2149 +5036 4 23.0402 41.1884 25.9461 -38.539 -4.36769 -14.447 +5037 6 9.79432 25.5848 27.2203 6.65484 -20.1236 -27.319 +5038 4 10.0774 24.9678 26.4912 -4.54744 21.2611 22.5851 +5039 4 10.2742 25.3181 28.0139 -2.97183 -5.43805 2.20583 +5040 6 35.2559 29.8148 24.7567 4.66903 26.9266 -5.93859 +5041 4 34.3843 29.755 24.359 -8.51564 -12.4096 -2.57191 +5042 4 35.4992 30.7322 24.5163 3.09853 -9.53322 8.65044 +5043 6 2.14554 4.24448 10.5593 -22.2482 14.7122 10.1934 +5044 4 1.71214 4.34677 11.4486 21.0071 -10.277 -13.7719 +5045 4 1.55235 4.73342 9.96914 3.10164 -3.012 2.95666 +5046 6 43.1737 3.93442 23.504 -19.8173 -22.9925 0.828755 +5047 4 43.8868 4.03822 22.8829 13.7397 8.75634 -8.56433 +5048 4 42.5624 3.30318 23.0634 7.12322 11.7882 3.68849 +5049 6 18.8936 22.6308 2.43475 37.4693 -11.6119 5.39147 +5050 4 19.8359 22.2985 2.41568 -31.8063 3.38645 -2.45846 +5051 4 18.7431 22.7947 3.37318 -4.67781 1.83629 -1.28906 +5052 6 20.5039 18.9394 41.5502 -45.0653 -1.00263 50.2155 +5053 4 20.0478 18.6838 0.506021 30.3651 -1.16827 -32.2456 +5054 4 19.9073 19.6506 41.2865 12.7012 -1.26976 -15.3796 +5055 6 26.407 7.54687 29.1121 1.4357 2.47637 1.41449 +5056 4 25.6724 7.10479 28.6297 19.9382 8.96422 9.98625 +5057 4 27.0918 7.77745 28.4582 -11.2115 -7.41118 6.83701 +5058 6 25.6474 35.5684 33.7551 28.3954 -27.4775 -24.9773 +5059 4 26.3573 36.1942 33.5448 -9.56627 7.56335 10.8035 +5060 4 25.9974 34.7724 33.2466 -29.6941 19.0168 23.1671 +5061 6 24.829 0.49304 8.41898 49.9168 25.8876 59 +5062 4 25.5758 0.370102 9.1289 -47.1903 5.46774 -40.7742 +5063 4 24.7798 41.5674 8.0141 -4.73142 -31.3088 -22.2887 +5064 6 17.0191 17.3177 3.44507 -46.3903 19.7373 51.2207 +5065 4 16.2469 17.9517 3.64762 33.8447 -23.651 -21.8207 +5066 4 17.1185 16.9245 4.35427 5.98982 5.76213 -27.3591 +5067 6 40.1787 32.0965 19.3495 -2.04197 44.459 1.39821 +5068 4 39.7315 31.3261 19.6693 2.08081 -28.8107 0.337304 +5069 4 40.9568 31.869 18.8472 6.84111 -19.9226 -1.15348 +5070 6 23.382 26.6945 6.30636 26.5913 52.1271 15.5788 +5071 4 24.0556 27.4456 6.44648 -17.1373 -33.2326 -1.34025 +5072 4 22.7142 27.1153 5.75328 -6.08389 -4.52619 -7.61988 +5073 6 28.6524 28.5085 1.41248 40.8971 -13.4399 -11.1281 +5074 4 28.8916 29.4207 1.30452 -22.1266 20.7664 -4.28256 +5075 4 29.5558 28.1704 1.18501 -32.1523 -8.03877 13.3744 +5076 6 12.0456 6.33448 14.0345 -15.8903 -34.4 -29.7535 +5077 4 11.2902 6.05291 13.4483 16.0844 18.9407 21.6686 +5078 4 12.7823 5.99392 13.4906 5.33453 16.7776 14.1371 +5079 6 20.1258 33.7078 32.0959 -18.1893 1.56867 -4.93457 +5080 4 20.1945 33.0222 32.7471 -6.29187 -8.74149 18.477 +5081 4 21.0272 33.8529 31.8657 20.6776 7.89431 -10.0095 +5082 6 12.0665 33.3691 34.5458 -17.2285 -56.0193 -22.1145 +5083 4 11.5086 33.8793 35.1106 -7.76206 16.4549 16.9315 +5084 4 11.5605 32.4987 34.4127 27.4292 33.0374 0.608769 +5085 6 6.00658 22.2666 25.0532 -19.3255 -5.39958 94.237 +5086 4 5.834 22.4197 24.1868 -9.01045 11.6196 -89.8037 +5087 4 5.17345 22.6031 25.4913 31.6285 -9.76338 -3.83253 +5088 6 28.8848 9.49767 11.035 16.7623 9.63116 22.4077 +5089 4 29.0495 10.2086 11.6768 10.1151 -22.3542 -11.392 +5090 4 28.083 9.83925 10.6889 -25.6685 -5.48517 -25.0151 +5091 6 25.9808 31.1499 24.8669 6.22835 -24.9986 7.12483 +5092 4 26.2942 31.9621 24.5011 4.31737 18.7644 -10.9339 +5093 4 26.6597 30.4768 24.6157 -18.0541 8.02771 8.13926 +5094 6 17.4051 22.6403 26.9653 -7.75883 36.9734 2.0054 +5095 4 17.2144 23.5004 27.4753 3.96627 -41.4428 -18.3441 +5096 4 17.5261 21.9375 27.6083 1.93016 -8.19761 6.25563 +5097 6 30.9714 17.6252 1.64088 21.0154 14.9482 37.3685 +5098 4 30.2059 17.6112 1.0839 -20.4324 5.80492 -14.3468 +5099 4 30.9516 18.4373 2.23396 3.22156 -25.7853 -22.8165 +5100 6 35.2764 9.72503 11.2414 -18.3895 -2.76749 -51.624 +5101 4 34.6551 9.56245 10.4589 20.7383 2.80865 37.1903 +5102 4 36.1302 9.43155 10.8742 2.68762 -2.05229 10.7544 +5103 6 12.0172 10.802 4.27563 -38.9121 -6.07101 -4.90761 +5104 4 11.4313 10.6374 5.04504 13.8247 1.49432 -7.40831 +5105 4 11.4074 10.5604 3.53263 22.811 5.33779 9.30002 +5106 6 52.9577 23.1313 7.67787 -9.3269 3.09364 -7.79077 +5107 4 53.8153 23.0871 7.22609 1.51949 2.98805 -1.25247 +5108 4 52.6879 24.0607 7.78743 10.5919 -6.87524 0.0783357 +5109 6 27.3762 5.80009 23.1013 37.771 37.8703 25.2466 +5110 4 28.2178 5.56094 23.5856 -32.2451 -1.57897 -13.9899 +5111 4 27.4704 6.79781 23.0764 -15.1432 -38.3322 -6.34326 +5112 6 22.7771 37.7063 15.5287 -6.89324 -10.2053 44.7861 +5113 4 22.8198 37.7465 14.5962 3.81902 5.91484 -35.4551 +5114 4 23.2903 36.9427 15.8415 -1.83068 2.7653 -4.67104 +5115 6 30.583 30.1381 39.7472 11.9278 5.78959 4.89923 +5116 4 30.1399 29.6129 39.0656 -4.27402 4.25284 -2.63349 +5117 4 30.6547 31.067 39.4612 -8.3831 -13.7724 -7.9353 +5118 6 26.5154 14.8633 29.9609 11.0831 -12.5589 -33.9006 +5119 4 25.6935 15.2477 30.2118 -18.1143 15.4408 19.147 +5120 4 27.1376 14.9035 30.6723 6.99544 5.71887 23.1856 +5121 6 9.52617 19.5446 37.4141 -27.8096 33.0225 -3.94279 +5122 4 8.56344 19.6819 37.5998 22.5694 -19.9005 4.13551 +5123 4 9.71087 20.3892 36.9619 8.68778 -16.8671 10.038 +5124 6 0.93064 14.8656 2.69338 -45.7679 -11.5139 71.6593 +5125 4 1.44105 15.217 2.01526 37.3122 25.2366 -40.5783 +5126 4 0.982855 15.4275 3.5214 11.2099 -15.0526 -29.9277 +5127 6 46.4291 27.1302 41.5927 44.8021 -5.11347 -18.4756 +5128 4 47.4269 27.1857 41.3316 -52.8753 -1.56841 10.8767 +5129 4 46.0453 26.5632 40.9031 3.09365 7.20255 7.14326 +5130 6 47.6703 23.0461 21.3817 14.1329 62.5249 18.4178 +5131 4 46.9615 23.2467 20.7836 -14.1781 -2.67912 -10.5965 +5132 4 47.8255 22.1376 21.4096 0.736735 -54.6337 -3.62162 +5133 6 39.861 22.2186 3.09273 14.3751 -13.6386 -17.8056 +5134 4 38.9812 22.2192 3.47284 -7.54245 -0.786418 6.90323 +5135 4 40.0217 21.2868 2.78929 -10.5756 29.8648 14.1337 +5136 6 14.9857 14.9315 33.4628 8.45923 30.4043 17.83 +5137 4 15.3946 15.8263 33.6275 -11.7248 -28.7506 -9.93609 +5138 4 14.5839 14.7058 34.318 1.67348 -1.86342 -8.89677 +5139 6 27.3225 11.4951 31.9326 -53.5602 -46.3542 13.457 +5140 4 26.8632 12.0627 32.5566 10.8872 8.4751 3.08438 +5141 4 28.1269 11.8297 31.6518 53.6341 36.944 -15.9306 +5142 6 36.7606 7.97817 7.63938 -5.6216 -14.483 -15.6739 +5143 4 35.961 7.43887 7.80711 8.78578 3.79539 -7.6162 +5144 4 37.414 7.37034 7.2323 -6.45073 3.96969 3.37374 +5145 6 49.4351 9.64395 18.2091 29.626 55.2849 10.866 +5146 4 50.1121 10.1978 17.7651 -9.80365 -29.4086 -13.348 +5147 4 49.2806 10.2909 18.9191 -22.4891 -21.6225 2.73598 +5148 6 27.0558 33.8708 10.7695 -35.2964 21.4972 9.63291 +5149 4 27.0077 33.3399 10.0051 13.5655 -23.8621 -34.587 +5150 4 26.1863 34.3133 10.6733 10.9844 1.63438 18.9088 +5151 6 11.1931 37.467 6.82672 4.88099 -16.6436 19.1561 +5152 4 10.8369 38.341 6.72067 -6.30082 13.8936 -5.38019 +5153 4 12.1372 37.6177 6.93955 5.33816 -5.06614 -4.03667 +5154 6 19.2682 19.4041 21.904 -23.2853 8.1035 46.9014 +5155 4 18.5523 19.4276 21.2977 -21.2798 -5.04156 -20.5384 +5156 4 20.0545 19.4439 21.4012 35.6905 -5.22778 -21.4405 +5157 6 54.5004 2.91828 22.5705 32.5661 -1.01917 48.733 +5158 4 54.2618 3.02388 21.6728 -2.16971 10.501 -40.9175 +5159 4 0.435524 3.25313 22.7695 -30.9494 -6.38648 -13.13 +5160 6 45.0599 10.868 24.2364 14.5135 -18.2796 4.13426 +5161 4 44.3635 11.4663 23.9664 0.226806 13.7258 12.1538 +5162 4 45.5813 11.1999 25.0017 -10.9868 0.331296 -15.4884 +5163 6 14.3917 34.4176 24.7766 -9.76404 -18.453 -6.38428 +5164 4 14.7761 35.2693 24.9957 4.99605 2.44674 1.2141 +5165 4 14.8449 34.0832 23.9904 0.575187 7.45256 -7.27956 +5166 6 50.5869 17.5623 4.30497 19.1488 -58.6727 24.3661 +5167 4 51.3501 17.8958 4.78847 0.670503 12.5806 -1.04554 +5168 4 50.1422 18.2474 3.88142 -19.7161 48.0777 -23.3625 +5169 6 14.9242 33.337 34.1076 -18.6172 33.5363 80.554 +5170 4 15.0808 32.9083 33.3321 11.226 -38.5345 -73.3592 +5171 4 14.0723 33.0217 34.4665 7.96171 10.4343 -9.42002 +5172 6 20.8631 33.5747 38.9135 21.2953 11.2024 -25.7312 +5173 4 20.865 34.0752 39.7143 -3.94121 7.45437 24.6588 +5174 4 20.36 32.7884 39.0656 -12.436 -21.6406 1.81461 +5175 6 7.7707 4.74963 26.7362 26.5342 -10.6541 19.1955 +5176 4 7.23261 4.91898 27.5026 -6.83786 10.9421 8.37469 +5177 4 7.15089 4.73593 26.0203 -3.95236 1.60233 -15.9617 +5178 6 9.2875 21.4887 22.2941 45.0197 -19.5209 20.7118 +5179 4 8.6739 21.9912 21.7696 -4.21454 15.1903 -23.2464 +5180 4 10.2572 21.6206 22.0058 -46.5259 5.6334 -2.177 +5181 6 20.5439 38.2154 8.85856 -11.8412 3.64647 49.7312 +5182 4 20.3505 38.5634 9.79035 9.75602 -4.66312 -40.2998 +5183 4 20.2844 37.2891 8.95048 10.2824 2.6457 -7.05014 +5184 6 30.1005 39.0839 30.7484 -12.1958 38.1552 23.9792 +5185 4 30.3724 39.9578 31.2326 -12.541 -45.9124 -25.2432 +5186 4 29.1103 39.003 30.8437 30.6219 6.07536 -1.13857 +5187 6 16.0462 22.036 24.5064 2.37861 -9.55962 -5.99251 +5188 4 16.6334 21.9741 23.7207 6.17482 7.89117 19.2285 +5189 4 16.5569 22.3155 25.2979 1.4399 -2.17025 -8.02685 +5190 6 5.74172 29.2061 14.4603 -14.7312 11.1013 -1.58992 +5191 4 6.41865 28.6839 14.8489 24.8954 -16.4528 0.429681 +5192 4 5.37542 29.618 15.2515 -13.4536 5.99623 -6.25212 +5193 6 28.0689 3.08071 25.2267 -3.20814 35.3244 14.901 +5194 4 28.6407 3.76435 24.8336 -2.36389 -14.401 -4.10269 +5195 4 27.6795 3.6106 25.9691 7.41152 -23.0621 -10.2478 +5196 6 45.9381 29.3111 31.4283 -35.5447 25.9568 9.82539 +5197 4 45.677 28.707 30.7493 2.31008 -18.1922 -21.3643 +5198 4 45.1265 29.9079 31.4744 34.4717 -15.8255 11.1052 +5199 6 11.2229 22.8376 36.7897 -1.27591 2.9175 -5.69903 +5200 4 10.6623 23.4314 36.25 10.4728 -5.78036 -0.0474996 +5201 4 12.0147 22.5841 36.2713 -9.37786 4.28983 5.66853 +5202 6 18.9444 40.1485 39.92 -15.471 -8.01044 2.33142 +5203 4 19.1439 39.1941 39.9507 -1.34087 5.25319 4.4419 +5204 4 18.8847 40.4877 40.8271 3.43659 -8.21326 1.76593 +5205 6 23.5503 26.0803 21.2869 1.98517 -8.46863 16.2364 +5206 4 22.847 26.649 20.9475 -0.393515 -5.32061 4.06564 +5207 4 23.2913 25.6403 22.1336 -2.29953 13.2014 -21.5927 +5208 6 16.8518 5.38834 15.8565 -25.8193 5.07215 -6.0744 +5209 4 16.3979 5.3834 15.0179 8.08064 -16.6857 -11.3384 +5210 4 16.3642 6.13153 16.2159 17.5374 8.90145 23.838 +5211 6 12.0293 26.6115 15.0052 48.8575 28.3431 -20.5386 +5212 4 11.753 25.9113 15.557 -22.1508 -25.2102 16.954 +5213 4 11.3677 26.9943 14.4309 -20.7091 -9.23994 -0.184726 +5214 6 14.3404 41.4231 2.37222 21.8802 31.2536 -15.2067 +5215 4 13.6639 41.0433 2.88545 -29.1815 -25.4177 23.2655 +5216 4 14.3137 0.446574 2.65591 6.04323 -12.5169 -2.89291 +5217 6 50.3994 35.8721 9.32148 7.74023 -5.00078 -0.0244409 +5218 4 50.7985 35.7097 8.44539 1.7624 12.9821 5.72804 +5219 4 50.9327 36.5364 9.8137 -9.76519 -8.88391 -14.7497 +5220 6 11.3732 22.6657 26.8674 13.5542 4.36995 9.37334 +5221 4 12.2226 22.4007 26.49 -3.86507 -2.48494 3.34128 +5222 4 10.7274 22.4174 26.2153 -14.8849 -5.84603 -9.40936 +5223 6 8.44501 34.5567 21.2657 -4.1178 -59.9386 7.63204 +5224 4 8.06567 35.1301 21.9247 -8.42944 2.78434 16.8569 +5225 4 8.10966 33.58 21.4462 13.1168 58.8803 -11.2866 +5226 6 9.4289 8.66253 24.4817 -31.3326 14.2813 -20.5935 +5227 4 8.45611 8.64572 24.2655 24.8039 10.7682 6.42659 +5228 4 9.52915 9.21836 25.2644 -0.461641 7.68001 5.20174 +5229 6 32.603 22.3274 34.5057 1.1064 -2.38466 -37.2003 +5230 4 32.4525 23.1707 34.0368 4.85154 -2.46017 7.68642 +5231 4 32.8396 22.5701 35.3818 7.58742 14.9461 32.9529 +5232 6 26.736 26.1837 7.12165 10.4716 16.8024 -17.1295 +5233 4 25.9537 25.8031 7.51207 -7.84415 -15.2109 12.7352 +5234 4 26.4604 27.1054 6.93432 8.77765 -19.2484 4.4957 +5235 6 34.0014 11.9295 3.96807 -3.56186 4.82634 5.33773 +5236 4 33.6494 11.5631 4.78494 7.3544 2.33703 4.85457 +5237 4 33.8594 12.8842 4.06904 0.478869 -2.08104 -5.13073 +5238 6 21.473 20.924 37.1992 5.8677 19.4674 12.3893 +5239 4 22.3242 21.3752 37.157 2.6693 1.87465 3.04951 +5240 4 21.708 20.0203 37.0255 -6.20277 -25.1527 -1.47337 +5241 6 18.4792 41.0219 0.672743 -35.2491 -25.3697 -26.4792 +5242 4 17.5363 41.1592 0.451811 6.2729 -6.09178 6.10687 +5243 4 18.7532 41.8934 0.847545 18.5165 37.9853 8.81983 +5244 6 41.3458 41.7141 25.1818 17.8335 14.8146 -1.57438 +5245 4 40.8444 40.9381 25.3951 -6.7286 -20.9895 5.67055 +5246 4 41.5773 41.6158 24.2546 -2.61686 2.51709 -2.2804 +5247 6 27.6337 28.128 3.93443 68.2433 49.922 -72.4808 +5248 4 27.747 28.0641 2.90056 -5.60951 6.59214 55.905 +5249 4 26.974 27.5707 4.19301 -60.7891 -51.6503 16.466 +5250 6 18.2766 10.5218 31.4985 31.6557 -13.945 -4.11948 +5251 4 17.4661 10.038 31.5755 -21.8827 2.32902 1.26527 +5252 4 18.1351 11.463 31.4681 -8.30794 8.79106 3.21692 +5253 6 11.3047 37.9513 14.7719 14.2766 22.5792 8.51892 +5254 4 10.8196 37.2524 14.3384 -3.55752 -10.2024 4.33151 +5255 4 11.8722 37.607 15.4977 -19.1201 -2.12261 -16.4117 +5256 6 0.810718 18.1323 27.5767 30.9572 19.3393 -0.702274 +5257 4 0.190255 17.4711 27.3024 -13.6082 -17.9307 4.12615 +5258 4 1.6652 17.6816 27.7433 -15.3641 2.36995 -0.952151 +5259 6 36.7957 10.7342 20.2882 16.9593 17.0847 7.18326 +5260 4 36.2525 10.0089 20.0111 -13.8544 -11.0907 -5.31633 +5261 4 36.5766 10.8708 21.2175 -0.466777 -2.92115 4.06643 +5262 6 47.4269 25.5204 8.035 -8.77625 7.04012 -26.0141 +5263 4 47.2351 25.672 7.07342 16.0738 -5.10236 26.6147 +5264 4 46.6031 25.1946 8.38488 -7.38433 -0.0309169 8.21918 +5265 6 13.9121 35.1279 15.9963 57.6206 21.904 15.8158 +5266 4 13.18 34.6338 16.2776 -41.6081 -30.4219 4.97616 +5267 4 13.8612 35.4714 15.1124 -11.7278 3.29634 -19.5683 +5268 6 29.56 35.3617 16.1847 -46.2751 8.28104 -14.7299 +5269 4 30.2098 34.9035 16.6971 16.3841 -9.08849 15.1595 +5270 4 28.6495 34.9755 16.3324 34.0842 8.73794 -6.93478 +5271 6 29.4892 25.8842 32.4194 -24.256 -10.4352 -29.1805 +5272 4 28.8256 25.7516 33.0892 -1.91161 2.59937 23.0953 +5273 4 29.0388 25.4531 31.6468 24.6149 5.96309 7.68736 +5274 6 24.1242 2.12171 25.4449 33.2745 25.8541 -21.7468 +5275 4 24.4973 2.84525 24.8288 -6.14236 -31.0627 26.9036 +5276 4 24.7925 1.39916 25.5361 -16.9688 12.032 -10.1501 +5277 6 4.54733 34.4389 19.1463 -35.302 -7.10976 -3.39284 +5278 4 4.35486 34.5879 18.2161 16.9971 0.874352 -7.12679 +5279 4 3.63202 34.4395 19.5005 25.743 -3.14875 11.9651 +5280 6 10.1206 17.2361 14.3164 8.36708 -29.6599 -28.3251 +5281 4 10.306 17.5039 15.1955 -0.106022 16.7729 24.4966 +5282 4 9.5035 17.8022 13.8616 -7.59249 10.3925 2.01091 +5283 6 21.4437 41.7724 34.6698 -12.6382 -8.67476 11.1219 +5284 4 21.3209 41.1297 35.367 19.1323 -10.7035 11.8578 +5285 4 20.52 0.052046 34.4982 -0.738196 4.11389 -17.598 +5286 6 36.1618 24.1149 12.6039 -38.5184 -29.276 -18.6614 +5287 4 35.5274 23.7914 13.2897 25.4622 4.78071 -2.2183 +5288 4 35.751 23.7447 11.7708 17.6549 15.9976 15.8112 +5289 6 49.5813 18.6026 19.9424 19.3655 4.31785 -3.79274 +5290 4 50.05 19.3681 19.5461 -11.4841 -9.87428 2.01803 +5291 4 50.2881 17.9408 20.0283 -8.44417 3.53865 1.64593 +5292 6 1.24663 7.05846 14.4912 39.2605 -25.8072 -27.0237 +5293 4 1.83321 6.85564 13.6734 -27.5618 7.792 37.3713 +5294 4 1.40902 6.33035 15.1313 0.69425 14.6008 -10.3474 +5295 6 12.7431 22.7725 31.2519 -28.0711 -22.2846 -24.537 +5296 4 12.731 22.0484 30.5842 -1.03989 14.4355 17.1556 +5297 4 13.6361 23.0601 31.2889 29.0982 7.61123 0.941905 +5298 6 8.17623 18.6217 27.8167 28.4831 -7.95646 -20.137 +5299 4 8.40342 17.6669 27.8028 -7.19499 14.8132 8.92302 +5300 4 8.90402 18.9943 27.2753 -13.5351 -1.9306 8.34595 +5301 6 52.1398 28.0368 15.3061 -5.99984 -2.63203 -6.56281 +5302 4 52.212 27.4921 14.5152 3.50742 -7.1981 5.43712 +5303 4 52.1344 28.9249 14.9274 -1.52971 -5.17654 6.68842 +5304 6 52.6974 21.8977 10.081 -19.9085 6.90605 5.3514 +5305 4 53.3388 22.3376 10.626 19.2735 6.64212 5.60719 +5306 4 52.8023 22.3165 9.21858 0.448532 -1.39229 -3.54893 +5307 6 22.3312 5.79987 2.67028 14.2956 -6.96789 22.7666 +5308 4 22.4342 5.66665 3.62826 -7.95027 2.50856 -4.24886 +5309 4 22.7763 5.02131 2.34757 -2.68692 -18.1597 -17.0707 +5310 6 15.4178 16.2178 21.8878 29.1139 16.3559 -34.9346 +5311 4 14.4763 16.1482 22.0206 -17.0561 3.51129 1.66656 +5312 4 15.5967 16.6295 20.979 -16.1676 -12.6325 35.129 +5313 6 28.6996 41.2944 33.8986 -0.299799 0.972013 4.01662 +5314 4 28.6528 40.5712 34.5346 5.69191 -6.81028 -1.89437 +5315 4 27.7925 41.4039 33.5788 7.00998 2.71453 4.16387 +5316 6 9.0271 31.2603 18.2166 -24.0632 3.5617 9.69965 +5317 4 9.00312 32.2249 18.3215 -0.833429 -0.795431 1.49639 +5318 4 8.39564 30.8695 18.8792 23.5138 4.17381 -14.686 +5319 6 20.5401 20.4009 18.1765 -9.82111 13.5354 -7.0052 +5320 4 21.0961 20.6619 18.9088 6.00228 -1.57494 14.3732 +5321 4 19.8969 21.1451 18.1138 9.42471 -20.4088 -2.28899 +5322 6 53.9632 14.7108 37.8185 38.9936 -13.777 37.4998 +5323 4 53.5065 15.4999 38.0588 -19.2143 21.2037 -5.62994 +5324 4 53.6553 14.2856 37.0504 -18.643 -5.89619 -29.3657 +5325 6 28.9005 15.3805 18.8553 43.4355 2.75939 -10.7082 +5326 4 29.8744 15.2601 18.5577 -43.1698 -4.30042 15.6378 +5327 4 28.8821 15.3937 19.8257 1.95554 -2.72042 -0.550014 +5328 6 2.00757 25.8231 18.9102 1.56834 13.1457 16.4238 +5329 4 2.16994 26.6099 18.3718 5.10623 3.14141 1.15535 +5330 4 1.76535 25.1325 18.3092 -5.75322 -15.1157 -18.9078 +5331 6 53.2586 40.7003 24.294 -3.95682 23.2035 5.10337 +5332 4 53.3627 39.7881 24.0333 10.577 -13.1769 -1.30533 +5333 4 54.0929 41.151 24.0537 -8.8009 -7.19084 1.91562 +5334 6 47.531 32.0044 22.8424 -9.22212 4.73076 14.8806 +5335 4 47.3777 32.6735 23.5302 -5.63931 6.65432 -9.88941 +5336 4 48.2144 31.4763 23.2497 9.41484 -5.26157 -3.09765 +5337 6 24.6289 26.1478 33.0175 -22.0968 -9.02062 -12.6011 +5338 4 24.4656 25.5474 33.7557 -1.10221 8.12594 5.97613 +5339 4 25.4283 26.6445 33.1202 14.9272 4.196 4.65224 +5340 6 21.3417 17.0876 39.4763 -6.70912 6.89414 0.748051 +5341 4 22.0272 16.5901 39.8927 14.9242 -9.38388 2.18929 +5342 4 20.9728 17.5957 40.2063 -4.43123 6.71259 -1.60026 +5343 6 11.0417 40.4515 17.0271 -4.84825 -47.9733 -31.3307 +5344 4 11.617 41.1325 17.3235 21.4854 16.9952 0.793724 +5345 4 11.529 39.8797 16.3454 -22.439 27.66 32.3414 +5346 6 20.3522 21.2696 39.8718 -25.2322 13.8952 23.2629 +5347 4 20.7065 20.9823 39.0558 13.3567 -12.8249 -34.1322 +5348 4 21.0787 21.2544 40.4999 1.2931 1.07094 1.93889 +5349 6 2.11891 29.6947 22.5962 -10.9271 -4.15175 -1.48688 +5350 4 1.41229 29.0196 22.6861 11.0269 1.69063 -12.8134 +5351 4 2.97173 29.2673 22.4434 -6.16143 -1.40449 -3.11444 +5352 6 36.756 30.301 35.4561 22.3149 -30.6991 6.56967 +5353 4 36.1659 29.9908 36.1617 3.98829 10.9575 -2.82389 +5354 4 37.5905 29.761 35.5884 -25.1141 24.4323 0.251817 +5355 6 12.9563 4.31922 37.9158 -41.9162 -7.49401 17.923 +5356 4 12.213 3.67486 38.0016 27.2031 5.98064 4.05536 +5357 4 12.5797 5.11915 38.3509 20.8388 -3.72048 -10.4757 +5358 6 38.3368 5.25882 18.4553 -27.9454 13.7946 -11.1943 +5359 4 37.494 5.12162 18.8921 -4.17763 4.09508 -3.9191 +5360 4 38.9486 5.03087 19.1262 32.9808 -9.34357 19.7422 +5361 6 10.4991 9.23341 21.7308 -20.3579 1.12747 21.1104 +5362 4 10.1476 9.35811 22.629 -2.53412 -6.58654 -7.03761 +5363 4 11.4429 9.27697 21.8681 13.0367 -0.194449 -11.5952 +5364 6 0.510441 41.039 17.3204 -22.411 45.8537 -1.19125 +5365 4 1.10275 40.3438 17.515 21.9532 -27.5034 12.6219 +5366 4 0.955429 41.8901 17.5577 -0.403404 -22.4144 -8.21181 +5367 6 4.11028 5.06714 6.43108 -32.0559 -10.673 -25.0156 +5368 4 4.76196 4.43778 6.68194 21.2279 -22.0503 -6.17775 +5369 4 4.3376 5.79555 6.94869 8.69612 42.0455 26.6358 +5370 6 11.4527 25.4042 0.173069 -8.87291 20.1751 -4.43043 +5371 4 11.3037 26.302 0.51034 -2.48968 -2.12098 1.34892 +5372 4 12.3912 25.256 0.330533 -7.09022 -12.0676 2.67745 +5373 6 7.43008 21.5598 8.10589 6.84767 -16.7382 -30.018 +5374 4 7.67559 21.2373 7.18738 -12.1375 12.6211 33.8068 +5375 4 8.24892 21.8626 8.52003 -6.07298 -1.72571 -6.46698 +5376 6 47.5896 16.3642 25.2431 -28.5582 13.6976 -25.6498 +5377 4 46.6075 16.1608 25.1822 37.2389 5.55574 -4.66364 +5378 4 47.8562 16.8152 24.3682 -3.16196 -14.4146 40.515 +5379 6 30.9292 19.5125 39.8483 -41.4217 8.94898 -20.4144 +5380 4 31.859 19.4188 40.0164 22.9308 8.40553 1.58818 +5381 4 30.7224 20.3633 39.3589 16.5857 -27.3682 15.8932 +5382 6 20.3871 24.0387 39.4036 8.00795 23.2793 -8.75093 +5383 4 19.459 24.1701 39.2693 -20.2994 13.2523 2.58474 +5384 4 20.4244 23.1071 39.4874 5.50164 -36.2952 5.14995 +5385 6 45.8871 21.2471 41.1655 20.5283 25.7578 0.477301 +5386 4 46.6385 21.2626 41.7552 1.12624 -15.6366 20.1575 +5387 4 46.1812 21.9667 40.5962 -14.858 0.0662744 -14.6758 +5388 6 32.5732 28.1983 30.4559 17.8923 -19.7368 14.2663 +5389 4 32.9661 27.3096 30.6426 -14.7491 22.8943 -8.37245 +5390 4 33.2232 28.8091 30.8453 -8.57676 -1.81844 -4.53088 +5391 6 18.0207 1.32021 27.0363 -34.7874 1.53884 20.0911 +5392 4 17.0721 1.60205 27.1202 27.3864 -5.2263 -11.315 +5393 4 18.3294 1.50373 27.9381 11.4124 1.84961 -11.8648 +5394 6 39.378 24.9761 21.8758 -21.83 -3.15726 3.51608 +5395 4 39.2925 25.9351 21.9975 13.0773 -1.30024 -1.60914 +5396 4 38.5262 24.6687 22.2439 10.6836 3.42961 -4.87158 +5397 6 33.5904 21.3057 22.0908 0.876878 23.3779 1.34154 +5398 4 32.7037 21.4589 21.7601 -6.64994 -10.6299 -4.35651 +5399 4 34.0298 22.1428 21.8479 4.87062 -13.8873 3.79153 +5400 6 40.1162 15.0006 15.7553 -16.7667 -72.1851 -56.1125 +5401 4 39.3246 14.5665 15.2764 38.6699 22.9899 20.5541 +5402 4 39.7685 15.7046 16.224 -23.0828 51.553 35.6364 +5403 6 32.7063 17.9241 6.36312 -6.65812 28.0098 -27.693 +5404 4 32.6631 17.3286 7.08836 -4.96405 -26.2659 23.6138 +5405 4 32.2202 17.5402 5.61621 0.349997 -9.22032 2.43078 +5406 6 50.4717 15.9308 31.1336 -57.0185 -34.1342 43.3708 +5407 4 51.2677 16.1483 30.7347 55.5832 16.4654 -29.6643 +5408 4 50.5499 15.0059 31.4683 -2.42192 20.1529 -11.8828 +5409 6 23.8292 29.3322 31.6407 10.3974 -8.56959 5.42825 +5410 4 23.7096 29.6981 30.7618 4.3803 -0.813234 -2.10966 +5411 4 24.6813 28.8378 31.6594 -15.3785 13.3689 -4.34977 +5412 6 25.0524 41.6477 38.2806 4.00174 7.46449 -31.3583 +5413 4 25.6511 41.367 37.5454 -10.3054 -0.491554 23.0497 +5414 4 24.5276 0.474703 37.8884 8.98972 -6.87862 14.9811 +5415 6 14.3299 25.4693 7.99598 -51.8246 -23.5651 26.6357 +5416 4 15.0301 25.7523 7.4663 39.147 18.3395 -31.3738 +5417 4 13.6749 25.0466 7.38907 19.2382 9.49844 7.52052 +5418 6 17.2117 20.7467 5.34291 -12.6959 30.9635 29.5807 +5419 4 17.5658 20.2645 4.6512 13.3362 -42.6322 -45.6451 +5420 4 17.6752 21.5763 5.21476 -4.76461 12.1014 12.8322 +5421 6 18.8578 10.961 23.7113 11.9098 -52.6755 14.4862 +5422 4 18.5821 10.3312 23.0139 -2.7304 18.9854 0.947207 +5423 4 18.7069 11.8432 23.4586 -8.32501 34.3086 -18.4054 +5424 6 7.80658 41.3805 11.0401 -9.04392 11.0606 6.15122 +5425 4 8.00429 40.5098 11.4059 2.67644 4.01258 -4.23655 +5426 4 8.51691 0.066 11.3394 -1.81513 -7.16892 -1.05394 +5427 6 48.6966 23.1832 34.0648 -27.3561 -6.76338 -18.0805 +5428 4 48.0792 22.9132 33.32 19.6766 11.2437 24.8207 +5429 4 49.5669 23.23 33.6693 11.2336 0.854645 -6.12438 +5430 6 53.7246 23.5588 15.3422 -2.2993 4.88061 -38.5045 +5431 4 54.0115 23.9686 14.4981 1.04624 9.96871 20.6807 +5432 4 53.2132 22.8493 14.9574 -7.54922 -9.79714 16.7607 +5433 6 22.2409 5.63035 9.83732 -4.74687 0.990813 -28.4051 +5434 4 21.8007 4.9012 9.36518 5.41421 2.33681 17.3637 +5435 4 22.5704 6.16354 9.07597 -3.08255 -9.23766 25.1176 +5436 6 33.6677 8.38805 9.07277 4.65141 2.45263 2.68713 +5437 4 32.9476 8.96499 9.32099 -11.143 10.7473 10.4723 +5438 4 33.4213 8.08448 8.2012 2.38155 -0.0587928 -10.5973 +5439 6 47.3188 37.7205 20.3441 15.215 11.7573 -25.0114 +5440 4 47.5704 37.5879 19.4187 8.2864 3.06637 8.88956 +5441 4 46.6261 37.0853 20.3703 -21.7602 -22.9037 19.9419 +5442 6 30.8605 16.7391 10.6102 -28.0995 -48.2853 23.2284 +5443 4 30.4428 17.1675 11.4048 8.00556 -5.70758 -17.8294 +5444 4 30.5213 15.7576 10.5828 6.17084 54.1408 -3.58748 +5445 6 48.1227 27.723 10.1192 -17.271 38.6552 19.8549 +5446 4 48.941 27.5885 10.6019 15.4404 -6.10886 -7.64033 +5447 4 47.9667 27.1056 9.42146 1.69339 -23.2576 -13.9441 +5448 6 27.3465 38.6397 25.5972 -19.3603 -43.7567 25.3821 +5449 4 28.2552 38.3171 25.6348 3.73027 6.4174 -6.06634 +5450 4 27.3175 39.4354 25.1025 9.7616 28.5552 -11.1584 +5451 6 33.3485 5.72785 21.4502 -30.5322 15.1217 -10.2054 +5452 4 32.7106 6.21453 20.8566 24.3968 -18.0484 15.2917 +5453 4 34.2142 6.02589 21.2258 21.3261 10.3595 -12.9949 +5454 6 25.3097 5.14436 4.52462 -12.6707 -6.42781 10.7366 +5455 4 25.8166 5.03621 5.34324 9.24373 -0.000563512 -7.52253 +5456 4 24.4109 4.89546 4.80865 9.45245 1.955 -8.20101 +5457 6 40.4804 35.6472 19.1595 -4.18239 -17.2552 -25.1441 +5458 4 40.6473 35.1871 19.989 -0.677015 6.66802 10.9293 +5459 4 40.3876 36.5867 19.2889 2.08163 9.85771 9.62751 +5460 6 49.6466 30.6357 19.0258 14.8172 21.4531 -43.5404 +5461 4 50.0494 29.991 18.4245 -6.82309 -11.6442 2.45506 +5462 4 49.4912 30.1943 19.8303 -8.11919 -24.8089 39.0949 +5463 6 42.1414 28.3198 17.0336 30.9261 -8.96587 16.5499 +5464 4 41.9014 28.1134 16.1233 0.612516 -1.09878 -6.61247 +5465 4 42.9986 27.8356 17.2327 -32.0588 11.6021 -17.9905 +5466 6 47.7009 24.529 36.3602 12.6164 -10.6945 -29.4467 +5467 4 46.9511 23.9476 36.4057 -12.614 -6.01445 14.1932 +5468 4 48.02 24.3175 35.4647 6.89481 1.31964 6.68358 +5469 6 19.3487 26.9773 19.8132 -7.91098 29.1703 -3.69101 +5470 4 19.5772 26.0513 19.7652 -2.42994 -17.6971 2.90599 +5471 4 18.7132 27.1892 20.5145 5.94626 -13.5516 -3.80193 +5472 6 47.0594 26.8038 37.5124 29.171 -27.35 55.5912 +5473 4 46.5442 27.3901 37.0243 -28.7601 35.2651 -40.4696 +5474 4 47.4575 26.1126 36.9775 -8.83233 1.8809 -11.4479 +5475 6 9.306 24.6801 40.2841 31.4937 0.109789 0.329283 +5476 4 9.78189 23.9102 39.8717 -14.0424 16.7407 17.3327 +5477 4 10.0272 25.2082 40.7306 -19.6308 -16.1327 -14.1874 +5478 6 14.4855 17.9139 14.2735 23.8217 -2.3356 -5.96097 +5479 4 13.7756 18.1909 13.6871 -0.445295 3.10639 3.20472 +5480 4 15.2926 17.8532 13.6969 -24.9099 1.36359 15.4275 +5481 6 37.1333 38.6708 18.7289 9.24178 15.507 -32.6939 +5482 4 36.7257 39.5382 18.5851 -4.02817 -0.227247 6.07181 +5483 4 37.6697 38.5833 17.9067 -2.91955 -11.3843 16.172 +5484 6 11.4153 5.92336 21.4477 15.4675 -15.5323 24.3843 +5485 4 12.0347 5.46444 22.0611 -14.8481 11.1792 -11.8992 +5486 4 10.9828 5.22117 20.955 -5.02219 -4.37746 -7.57367 +5487 6 4.24672 30.7112 16.2271 25.0754 -37.7862 10.5022 +5488 4 4.05441 31.4608 15.7204 -4.71706 34.9582 -31.1175 +5489 4 3.72964 30.8334 16.9988 -11.892 -2.06994 24.4228 +5490 6 17.6689 16.0105 27.0706 -11.532 -19.4613 -16.5334 +5491 4 17.475 15.0322 27.0999 0.550485 29.0366 -12.0979 +5492 4 17.2014 16.3875 26.2691 10.8221 -16.0252 20.0561 +5493 6 36.4979 8.6445 40.4253 22.1182 5.90925 -1.87084 +5494 4 36.6649 9.56092 40.6574 -3.64727 2.10984 0.486612 +5495 4 35.6642 8.36755 40.7885 -12.5441 -1.64485 2.44437 +5496 6 13.6104 12.9476 3.01337 -0.796658 -1.76047 52.4558 +5497 4 13.281 12.534 3.85665 2.0295 3.09436 -35.1239 +5498 4 14.3672 13.4568 3.35498 1.79634 -1.71495 -16.7359 +5499 6 38.5663 20.1511 21.6276 16.2684 -2.59448 10.3838 +5500 4 39.225 20.3435 20.957 3.66548 0.723189 -1.42015 +5501 4 37.7399 20.1987 21.178 -26.4348 -4.9091 -11.1397 +5502 6 51.0002 10.2707 30.836 -20.0759 -41.5967 21.7358 +5503 4 51.4945 11.0341 30.626 15.2265 30.1997 -10.6067 +5504 4 50.365 10.1656 30.1217 2.42758 1.75416 -9.76943 +5505 6 16.2768 2.44039 41.3342 24.5898 23.894 -47.9169 +5506 4 15.7659 1.68969 41.4668 -26.4768 -52.1654 31.458 +5507 4 16.2309 2.46185 40.3616 9.12406 8.41144 7.6857 +5508 6 16.5823 4.96192 41.8916 -4.82165 52.2801 -70.6027 +5509 4 16.7504 4.9538 0.881833 10.2709 -3.72182 62.3109 +5510 4 16.3825 4.09214 41.6138 -6.48385 -26.7637 5.90228 +5511 6 38.2132 37.6512 20.9834 35.6931 -0.0015793 9.16781 +5512 4 38.1132 38.2158 20.1985 1.71026 -5.63736 5.42755 +5513 4 39.175 37.679 21.2752 -35.8773 5.52261 -11.9395 +5514 6 27.3063 1.90932 15.7743 -36.1781 7.04456 22.02 +5515 4 27.5288 1.21363 15.1745 3.62804 -9.29946 -19.0329 +5516 4 26.3092 1.89423 15.8276 27.8398 0.929522 -3.41863 +5517 6 29.0129 12.4346 37.8081 29.6396 -2.3639 23.3235 +5518 4 29.5703 13.228 37.8521 -9.25731 3.38449 -11.2245 +5519 4 29.432 11.8866 38.5178 -20.735 6.92768 -10.3763 +5520 6 46.0725 20.1624 18.9069 6.39102 14.9163 -14.6323 +5521 4 45.1723 20.516 18.8892 1.91785 -0.379773 0.405435 +5522 4 46.587 20.7656 18.3221 -3.54001 -13.7442 9.74416 +5523 6 2.03634 38.6845 18.4933 3.82981 -3.85695 21.6638 +5524 4 2.81563 38.6864 19.0472 23.4807 10.2435 -12.678 +5525 4 1.45125 38.3557 19.1766 -27.1945 -1.99387 -8.3623 +5526 6 44.0469 24.9707 25.966 7.80173 10.6441 20.9452 +5527 4 44.2747 24.0363 26.0952 1.37736 2.33249 -4.33209 +5528 4 43.5784 25.0701 25.1359 -3.49858 -7.6437 -6.59112 +5529 6 5.98346 26.6137 4.53144 23.0758 4.04073 24.4329 +5530 4 6.55391 27.1627 5.13089 -15.1794 -12.3526 -15.6845 +5531 4 6.29729 25.6938 4.67268 -13.7287 18.2257 -9.78447 +5532 6 0.087877 23.2081 10.934 24.9145 3.46447 1.10559 +5533 4 0.685292 23.7315 10.3726 -8.08066 -2.01306 3.92681 +5534 4 0.721975 22.7627 11.5282 -19.4067 -0.934622 -1.78644 +5535 6 39.1228 20.6282 12.8796 23.5823 -4.01912 3.74068 +5536 4 40.0483 20.9095 13.1274 -25.2182 -11.8294 -4.75086 +5537 4 38.9288 21.0058 12.0111 3.51405 8.21934 1.48951 +5538 6 39.9585 39.9542 18.8548 8.25477 7.63818 -34.14 +5539 4 39.6086 40.5348 18.1328 12.8912 -23.3113 16.3656 +5540 4 39.4227 40.1355 19.596 -22.4924 5.25798 25.9214 +5541 6 49.2764 23.011 30.5163 -3.77364 -44.6036 15.8547 +5542 4 49.4289 23.7872 30.0082 18.6126 30.182 -14.9565 +5543 4 49.9621 22.8706 31.1946 3.66181 18.5012 -4.70792 +5544 6 10.3518 2.34263 9.13761 -0.60969 70.0656 33.4022 +5545 4 10.2194 1.51752 8.76453 -19.3013 -48.5596 -30.1763 +5546 4 9.57958 2.95755 9.02478 16.8019 -18.7251 -1.57756 +5547 6 9.61453 40.9339 19.7468 19.8516 -54.9951 -16.0575 +5548 4 9.63195 40.6865 18.7859 0.317082 16.3896 20.6195 +5549 4 10.0376 40.0904 20.1458 -24.9194 43.0231 -10.2629 +5550 6 29.2525 5.10109 17.4961 7.67774 22.6856 2.90325 +5551 4 29.0408 4.77134 16.6193 -6.82779 -3.03985 -6.7526 +5552 4 29.5295 6.02934 17.3335 -2.58265 -16.5067 4.76001 +5553 6 27.0985 15.4102 3.23556 -13.4453 -81.1273 -7.3603 +5554 4 27.3652 16.2806 3.27349 18.8182 67.1491 11.283 +5555 4 27.7776 14.8512 3.68225 -14.3437 21.6428 -0.863725 +5556 6 32.8444 39.3852 25.121 -7.01244 -52.8845 44.4676 +5557 4 32.5131 40.2222 24.9368 -10.8075 51.8916 -16.2411 +5558 4 32.4445 39.2315 26.0289 16.1191 -0.874654 -30.671 +5559 6 34.9513 7.88207 31.2328 20.4504 58.5219 2.42802 +5560 4 34.2036 8.45679 31.498 3.65199 -12.2289 -1.35309 +5561 4 34.6861 6.99719 31.2488 -20.0023 -44.0519 1.25651 +5562 6 6.12467 36.7605 26.1486 23.5936 30.152 20.8626 +5563 4 6.61267 37.4751 26.6609 -18.7565 -29.2185 -15.3031 +5564 4 6.64666 36.6639 25.3566 0.873799 -8.15108 -9.63468 +5565 6 6.01736 25.8242 24.1032 -23.71 11.4997 43.6127 +5566 4 6.27054 25.4519 24.9889 5.69321 0.899098 -34.3464 +5567 4 5.25039 26.3671 24.4036 11.002 -12.3451 -22.9516 +5568 6 45.616 24.3868 2.54557 6.93899 11.9467 -1.18645 +5569 4 46.5025 24.2318 2.18535 0.269069 -11.0786 2.08994 +5570 4 45.6283 24.2142 3.48441 5.93067 -6.10702 12.3332 +5571 6 15.5106 11.7053 32.6869 22.7313 15.5035 25.4621 +5572 4 15.7644 12.551 33.1413 -9.31293 -24.2108 -12.4541 +5573 4 14.956 11.9719 31.9681 -12.2379 8.7831 -14.7046 +5574 6 46.4141 17.7037 37.4783 -24.8433 -42.9552 -46.1347 +5575 4 46.5841 17.8832 38.3706 6.4658 9.03355 44.3658 +5576 4 46.0203 16.778 37.4148 6.08678 36.5836 2.96135 +5577 6 39.713 20.917 18.528 13.2313 30.5311 40.8197 +5578 4 40.433 20.5782 18.0298 13.2747 -18.0123 -24.5712 +5579 4 40.2054 21.5165 19.1543 -30.2447 -12.7963 -15.6911 +5580 6 23.8051 28.0334 36.6648 -18.7533 17.1228 48.8478 +5581 4 23.301 27.37 37.1661 8.15196 -5.41595 -20.5023 +5582 4 23.699 28.7533 37.3439 14.557 -4.10395 -29.4534 +5583 6 23.235 0.659798 30.8906 16.7198 -34.3804 0.301059 +5584 4 23.3562 41.8891 31.5781 -2.93034 5.1259 -1.85649 +5585 4 23.9222 0.433479 30.2226 -16.4688 10.6885 3.12481 +5586 6 37.1438 6.89027 28.2945 -2.75708 2.50278 32.0481 +5587 4 36.7625 6.23385 28.9496 14.7229 22.3106 -21.8828 +5588 4 37.4874 7.65333 28.8474 -13.0775 -21.14 -18.6628 +5589 6 3.23769 6.61111 12.3846 0.723209 -17.9385 -9.61551 +5590 4 2.93962 6.7917 11.4726 6.04883 11.0603 10.3219 +5591 4 3.59705 5.70622 12.3141 -7.8292 10.6871 9.81534 +5592 6 12.6213 19.1513 31.1215 -11.7593 -39.2703 -9.13055 +5593 4 12.5689 18.1911 31.4279 4.41954 36.1073 -0.401864 +5594 4 12.3049 19.0952 30.1995 4.23471 8.33584 13.9505 +5595 6 15.1895 38.3194 41.5508 -8.26313 0.106571 5.96729 +5596 4 15.4027 38.685 40.6867 1.58925 3.7734 1.08261 +5597 4 15.977 37.8419 41.8199 8.82113 -1.67422 -0.112624 +5598 6 49.6344 33.3417 19.6414 -43.1776 -42.2962 -0.847743 +5599 4 48.6794 33.3996 19.9697 35.2792 3.84356 -17.7841 +5600 4 49.66 32.3974 19.2778 11.8172 40.1309 17.1575 +5601 6 6.36572 2.78375 29.9004 1.05055 15.8156 -22.8281 +5602 4 6.36575 3.75042 29.7262 1.90425 -15.9719 7.25575 +5603 4 5.96593 2.68858 30.7619 0.24665 -4.47807 16.8647 +5604 6 13.1696 31.768 30.2754 -6.44409 10.1839 -14.6274 +5605 4 12.7931 32.0108 29.386 8.00869 -8.49993 19.6421 +5606 4 12.9985 30.8211 30.4317 -1.17466 7.15103 -3.10169 +5607 6 32.315 32.2433 24.9103 28.3535 -13.0924 -48.465 +5608 4 32.6582 31.5201 24.3183 -18.8106 4.4732 28.5514 +5609 4 32.6906 33.004 24.4312 -3.21058 9.63112 20.1287 +5610 6 42.0003 14.5628 37.421 -39.889 12.6212 -8.37855 +5611 4 41.095 14.1415 37.3281 37.9102 -1.96214 -0.320241 +5612 4 42.7025 13.9066 37.3517 -4.02931 -15.6388 2.60245 +5613 6 11.8892 7.23447 27.6701 3.45884 -4.12236 4.5236 +5614 4 11.8415 6.40302 28.2109 -4.80024 17.2153 -14.4092 +5615 4 11.297 7.16355 26.8983 -0.411327 -9.99206 8.34553 +5616 6 14.2054 37.5349 6.88535 -5.50304 -50.1586 -23.8091 +5617 4 14.4448 38.4425 6.82842 11.1201 34.2121 -5.16838 +5618 4 14.5404 37.0855 6.04727 -8.45912 19.5264 31.302 +5619 6 14.2389 30.7101 36.0658 7.9951 22.3707 -6.00421 +5620 4 14.3369 30.7582 35.119 5.20948 5.89711 -15.5268 +5621 4 14.162 29.7856 36.1796 -2.50712 -40.828 17.27 +5622 6 16.4199 33.6465 5.49971 39.8982 -12.4718 -37.0106 +5623 4 16.8881 34.472 5.38053 -10.1033 13.7438 12.8324 +5624 4 16.9383 33.116 4.82328 -31.4907 -2.1142 22.2677 +5625 6 23.0347 17.1509 7.84843 -2.98061 53.305 10.417 +5626 4 22.2528 17.4913 7.37616 0.35347 -20.1342 1.7373 +5627 4 23.3535 18.0122 8.2624 2.91922 -40.8936 -9.01863 +5628 6 51.739 20.8998 27.7117 45.1346 -9.91933 19.8422 +5629 4 51.4539 20.5938 28.5983 0.576611 5.87017 -14.8878 +5630 4 52.7517 20.9693 27.7878 -43.3794 -0.870523 -11.1135 +5631 6 2.19386 27.6013 28.8077 21.9852 1.77593 -20.6905 +5632 4 2.90112 28.2633 28.7865 -8.94698 7.25322 21.5481 +5633 4 2.57794 26.9939 28.1568 -21.2327 -10.3447 8.82052 +5634 6 17.2209 14.3445 7.70498 -9.6153 -40.0176 25.3709 +5635 4 16.7414 14.2178 8.5755 19.2823 5.01031 -25.0594 +5636 4 17.7242 13.4894 7.54274 -12.7499 32.9606 1.11211 +5637 6 12.4553 8.94194 14.7093 23.4905 -30.5738 22.1451 +5638 4 12.3295 7.96561 14.6517 -10.6336 18.1935 -14.5798 +5639 4 13.0902 8.95069 15.466 -13.8235 22.031 -14.7981 +5640 6 42.4163 38.0607 9.75492 -41.3892 12.3524 0.930734 +5641 4 43.2155 37.8504 10.1985 23.5031 -2.65638 19.8551 +5642 4 41.8128 38.5249 10.3845 19.1619 -5.0707 -9.72644 +5643 6 51.8291 30.3524 28.2725 -23.4976 -15.3182 24.0858 +5644 4 51.4769 31.1806 28.0071 -16.9091 20.9854 -6.54852 +5645 4 52.5669 30.2698 27.7075 37.0459 -10.0857 -13.876 +5646 6 0.173291 18.5306 4.58887 -6.78508 26.3933 6.63194 +5647 4 0.366643 18.0957 3.77581 2.61413 -8.62723 -27.1515 +5648 4 0.528197 17.9664 5.25604 0.668563 -20.2899 17.5992 +5649 6 34.1542 0.618182 3.01035 -64.6642 7.59467 -29.5426 +5650 4 33.2756 0.91071 2.55681 38.9521 -14.8268 28.0312 +5651 4 34.8139 1.0189 2.46529 20.392 14.9436 -5.19898 +5652 6 49.1703 17.2445 23.163 11.3421 -28.7232 -23.3687 +5653 4 50.0948 17.5226 22.997 -11.4987 -1.8789 7.34388 +5654 4 49.1149 16.3391 22.7575 3.35316 27.0342 8.27414 +5655 6 23.1508 6.50484 23.6205 15.3745 23.1125 -33.0506 +5656 4 23.1854 7.14565 22.8174 -14.1016 -25.0292 28.8988 +5657 4 22.2566 6.27815 23.8868 -11.3625 11.3028 -1.57795 +5658 6 11.0777 24.0866 29.2726 3.42799 -14.5151 -26.2344 +5659 4 11.3051 23.4915 28.5104 -10.7193 12.1306 15.2701 +5660 4 11.7189 23.8646 29.9475 6.00027 1.59973 10.1126 +5661 6 36.5499 4.08922 21.6769 -9.80126 5.87302 -21.3361 +5662 4 36.3976 4.50823 22.521 3.21878 -0.144303 13.033 +5663 4 36.3054 4.80832 21.0596 6.63301 -13.9203 1.83546 +5664 6 31.3023 25.6432 24.5943 15.0376 6.85795 28.0728 +5665 4 31.291 26.2789 25.3519 -12.6017 -14.5788 -25.478 +5666 4 32.0941 25.1064 24.7955 -9.59576 -0.449362 -7.93794 +5667 6 42.6065 23.029 14.7662 -46.2562 -12.0705 -53.1337 +5668 4 42.8654 23.3474 13.8766 8.33796 6.77145 13.2285 +5669 4 43.1929 23.285 15.4255 44.8404 21.8098 38.991 +5670 6 14.3111 11.6689 8.88632 -19.0153 -23.9468 -21.906 +5671 4 13.3495 11.3817 8.87766 31.9146 14.5471 0.24728 +5672 4 14.742 11.0378 8.25313 -7.14597 12.5116 20.7778 +5673 6 21.4992 2.13393 3.40246 8.36864 -2.88126 -9.61958 +5674 4 22.4231 2.22963 3.69686 -12.58 -3.45743 -2.69439 +5675 4 21.4721 1.34946 2.81138 2.62282 6.56171 18.4043 +5676 6 22.4667 27.6841 39.0793 -16.1771 -11.2193 -33.3168 +5677 4 22.9487 28.2311 39.6723 13.8114 13.1168 21.0188 +5678 4 22.2331 26.8853 39.529 -0.753476 -8.75647 11.2468 +5679 6 37.2752 33.5075 30.0534 -5.09816 -29.8969 21.2662 +5680 4 36.5321 32.9121 30.2938 11.1992 13.6878 -5.37502 +5681 4 38.0391 33.1092 30.5204 -9.59535 7.6329 -11.7718 +5682 6 41.8356 20.8755 40.0084 -30.1785 -26.2846 -15.3963 +5683 4 40.891 20.6843 40.2338 21.7839 7.55089 -6.55796 +5684 4 42.213 21.2736 40.7728 12.4306 8.07023 23.0746 +5685 6 10.0585 31.1051 22.2503 24.8691 -18.1602 32.094 +5686 4 10.0242 30.9652 23.2199 -0.323131 -4.21186 -18.2592 +5687 4 9.26251 31.5457 22.0526 -32.5358 14.9165 -12.561 +5688 6 24.2061 35.3797 6.65176 29.8647 -7.74501 -52.0461 +5689 4 23.2981 35.13 6.46942 -12.5131 3.59528 11.7489 +5690 4 24.436 35.6291 7.5325 -13.5066 3.92126 26.0938 +5691 6 54.2205 13.3707 18.7548 -14.8606 0.23157 2.49876 +5692 4 53.5905 13.2954 18.0026 12.0308 5.79113 16.3195 +5693 4 53.7072 13.5032 19.578 4.97112 -2.65932 -16.1217 +5694 6 12.4895 25.0856 17.4479 -5.54126 21.12 19.6166 +5695 4 12.0527 25.8035 17.9613 1.96295 -15.4272 -10.9144 +5696 4 12.9797 24.5872 18.1192 -7.22993 -2.38631 -13.5888 +5697 6 22.3914 33.9622 18.8899 -17.7941 -3.8788 -25.186 +5698 4 22.7777 34.3519 18.0802 1.20341 3.55679 12.7761 +5699 4 21.5828 33.5138 18.532 26.0363 5.82114 13.25 +5700 6 24.4442 12.917 5.83205 -1.35281 -9.13891 6.68087 +5701 4 24.5112 13.8355 6.04562 11.139 23.8521 5.95609 +5702 4 23.7978 12.9208 5.12829 -4.38592 -8.75699 -5.70796 +5703 6 13.4045 11.2384 28.602 -9.94106 -32.5269 -0.345522 +5704 4 13.7125 10.4202 28.1467 1.06973 22.7078 1.68844 +5705 4 12.6883 10.856 29.1417 2.50959 12.0169 -5.49025 +5706 6 20.9681 34.6931 21.1354 15.1203 14.42 -6.16036 +5707 4 21.5009 35.1121 21.8248 -8.94458 -7.77672 4.1779 +5708 4 21.5063 34.8208 20.3262 -11.2236 -10.4562 8.09593 +5709 6 37.1336 34.5207 26.1541 -9.5297 -36.7224 -3.07541 +5710 4 37.2109 34.2142 25.2288 3.21082 15.1766 11.7274 +5711 4 37.5352 35.3664 26.2639 8.9577 18.3348 -6.65469 +5712 6 49.3622 27.1182 23.4746 39.7066 -11.0301 13.9767 +5713 4 48.4746 27.3502 23.3119 -43.65 9.96054 -8.06751 +5714 4 49.6716 26.7458 22.6451 -3.30563 -9.15784 -7.68388 +5715 6 2.6564 41.733 27.6477 -1.65257 -10.3676 0.180548 +5716 4 2.5349 41.5868 26.6785 2.71482 14.5166 10.808 +5717 4 3.44733 0.360291 27.8573 -13.8821 -2.9337 -13.5775 +5718 6 28.2538 5.65865 0.855763 -50.2522 -11.1502 7.99105 +5719 4 29.1126 5.92525 0.635025 43.8938 8.11388 -11.2713 +5720 4 28.2366 4.68907 0.832778 5.05155 4.08711 2.73992 +5721 6 46.3376 19.9476 30.6448 -5.32264 7.02196 22.3264 +5722 4 46.9473 19.8004 29.9179 3.84913 9.17517 -5.42643 +5723 4 46.6125 20.7672 31.1318 -5.12963 -19.3092 -16.4827 +5724 6 3.64577 25.7701 21.5553 -12.766 27.4814 -12.397 +5725 4 3.72382 24.8593 21.8343 3.84868 -9.88757 -5.52558 +5726 4 3.13913 25.8588 20.7173 13.2009 -15.3518 9.10855 +5727 6 2.75122 19.0968 29.6319 -2.61118 -0.882922 8.96218 +5728 4 3.5891 18.6871 29.8565 3.14038 -9.81989 10.1431 +5729 4 2.90737 19.4327 28.7602 3.1882 14.1904 -12.7773 +5730 6 11.8953 35.7778 24.2646 -23.8517 23.4638 0.926703 +5731 4 12.2722 34.9198 24.2954 23.5909 -23.1933 0.784725 +5732 4 12.5229 36.3761 23.8548 12.2449 3.68762 -3.83655 +5733 6 52.3409 30.3775 14.3038 25.9342 24.3497 3.27132 +5734 4 52.8186 31.1218 14.7277 1.28259 -10.3571 -1.87569 +5735 4 51.5459 30.7912 14.0165 -25.7225 7.74731 -5.34623 +5736 6 0.083662 24.3704 32.1159 7.87696 -1.86575 0.949534 +5737 4 0.925887 24.7254 31.8116 -7.58302 1.2158 -10.0766 +5738 4 0.064605 24.6797 33.0182 -11.6947 5.89195 12.8097 +5739 6 31.4941 23.7355 38.8139 13.6067 4.55671 22.3988 +5740 4 31.5922 23.3599 39.6955 6.6148 17.5079 8.63317 +5741 4 30.9989 23.0266 38.4646 -21.4094 -18.5611 -29.2329 +5742 6 52.1193 21.6104 3.49599 14.6151 -31.0847 -13.388 +5743 4 52.9641 21.5934 2.99085 -20.8635 4.42776 5.19501 +5744 4 52.1025 22.4297 3.95509 1.85636 27.8943 8.87727 +5745 6 31.7523 33.9412 11.6017 9.59211 -24.6365 -8.99112 +5746 4 31.343 34.2459 12.4067 -7.95657 10.1636 10.9534 +5747 4 32.0734 33.0348 11.7994 -4.73133 20.193 -2.42319 +5748 6 7.03486 17.6719 16.6685 29.0057 -41.5114 -49.367 +5749 4 6.91092 17.0215 17.3537 -7.78637 4.64801 28.8113 +5750 4 7.29826 17.0034 15.9319 -18.9591 50.1453 28.7374 +5751 6 51.8542 41.8728 22.1898 10.246 17.2442 -13.5357 +5752 4 52.3028 41.4443 22.9054 19.3182 -6.61148 18.5368 +5753 4 51.1068 41.3135 22.0792 -27.0964 -11.4612 -2.03348 +5754 6 50.8737 9.93347 25.9376 -32.929 -21.31 0.307119 +5755 4 50.6075 10.0984 25.0351 -2.54905 2.45869 -5.94774 +5756 4 51.7134 10.3221 26.0527 29.2363 20.0336 5.9403 +5757 6 9.00178 39.8723 13.8451 -19.3622 -18.1235 -30.983 +5758 4 9.55792 39.3182 14.3856 9.60602 -5.37935 8.26515 +5759 4 8.70771 39.29 13.0873 14.4347 20.6992 23.854 +5760 6 40.6986 25.5526 0.136544 19.9096 -17.3535 33.0343 +5761 4 40.3666 25.3638 1.04053 0.834228 7.76146 -13.9079 +5762 4 41.6521 25.7245 0.296606 -16.7956 -8.725 -14.7957 +5763 6 46.6823 7.83196 22.8561 10.1499 25.8504 33.9562 +5764 4 46.2788 7.49308 23.6743 -2.78909 -8.0392 -13.1915 +5765 4 47.099 8.65892 23.1926 -4.50937 -8.82075 -14.1875 +5766 6 20.9875 12.9068 9.95805 -11.691 32.2034 24.7109 +5767 4 21.4351 12.3054 10.5167 21.854 -26.8991 22.1196 +5768 4 21.3309 12.7465 9.11062 12.4417 -9.66517 -44.3579 +5769 6 24.8453 0.514421 28.6038 13.082 22.7197 -2.81433 +5770 4 24.715 0.071792 27.7548 -6.16819 -1.63374 -2.91335 +5771 4 25.0442 1.45997 28.4028 -6.72102 -19.281 3.08734 +5772 6 9.94041 22.6855 8.28517 -18.2906 18.759 -35.6321 +5773 4 10.3442 21.9586 7.83344 17.071 -18.1108 1.7387 +5774 4 9.60436 23.1702 7.48056 7.13277 7.40532 33.7222 +5775 6 33.2759 9.25429 23.8257 8.37106 -55.2845 13.9355 +5776 4 33.3237 10.1123 23.4806 -1.26345 47.1757 -20.4798 +5777 4 34.1087 8.81977 23.5578 -8.47821 6.16632 5.2483 +5778 6 47.7984 20.3614 34.2959 -41.6158 20.0741 -32.6301 +5779 4 47.162 20.9095 33.7523 35.4977 -6.5354 18.8426 +5780 4 47.2264 19.5923 34.4121 13.8381 -6.37745 11.1074 +5781 6 7.49292 13.4971 41.09 9.79805 -11.8131 -23.6679 +5782 4 7.49901 13.1324 40.1715 -6.0705 12.8605 17.5951 +5783 4 8.32745 13.1637 41.4633 -5.36906 3.36653 2.36319 +5784 6 9.96112 23.6102 1.61114 1.89646 0.256416 -8.05524 +5785 4 10.3422 24.1467 0.893187 3.70522 0.0162214 12.766 +5786 4 9.63217 22.8308 1.16111 -2.5861 -8.4474 -3.4617 +5787 6 27.3279 14.1675 11.3384 -16.3978 3.93745 18.7515 +5788 4 27.0565 14.7974 10.6584 -0.154384 0.736593 1.51299 +5789 4 26.9739 14.5213 12.1957 15.9081 -3.44829 -24.7787 +5790 6 25.8416 31.7729 17.8867 -18.6075 -57.137 -13.4601 +5791 4 26.5498 31.1652 17.5816 -7.88637 19.42 8.67928 +5792 4 26.1364 32.6121 18.1157 31.0786 47.9057 11.8145 +5793 6 28.5054 34.3394 0.220618 54.67 33.5077 11.5224 +5794 4 29.0324 33.8757 0.885908 -4.94848 -3.20805 0.921423 +5795 4 27.711 33.8992 0.092994 -46.8158 -31.9819 -6.78258 +5796 6 39.4821 27.6754 22.7241 37.6977 26.8974 -34.7457 +5797 4 38.562 27.8477 22.7631 -35.1425 8.51836 6.28403 +5798 4 39.8483 28.4606 22.2037 -4.4779 -30.5719 17.4824 +5799 6 19.3989 35.5068 37.6449 44.7238 7.00696 26.241 +5800 4 18.7939 34.9286 37.217 -17.2642 -20.3375 -13.2178 +5801 4 20.0787 34.9056 38.0699 -27.4009 15.1777 -18.4057 +5802 6 40.2622 30.2205 10.7395 23.7464 -4.20556 -44.2191 +5803 4 39.872 30.2327 11.5724 -12.5687 -7.32393 56.9787 +5804 4 39.6265 30.6987 10.2193 -5.46151 14.1383 -16.826 +5805 6 44.8252 28.4803 36.0885 -55.5401 -40.4399 48.4955 +5806 4 44.0914 27.9458 36.6324 49.8455 26.3412 -39.6007 +5807 4 44.7386 29.3482 36.4954 11.2485 4.05282 -13.3799 +5808 6 17.9305 13.9374 34.278 5.37655 43.1893 -39.9004 +5809 4 17.3503 14.7126 34.0365 12.4853 -29.216 13.3111 +5810 4 17.5732 13.4499 34.9957 -23.6035 -11.4222 25.4792 +5811 6 22.772 11.7897 25.9182 -5.92321 66.9234 -24.4623 +5812 4 22.4079 10.9608 26.1065 -2.80798 -46.2844 14.8143 +5813 4 23.7282 11.8442 25.9391 13.2658 -20.917 3.34216 +5814 6 27.9678 31.9745 40.3581 9.67064 -3.036 11.5355 +5815 4 28.3415 32.7469 39.952 3.83939 12.9153 -6.44865 +5816 4 27.8423 31.3481 39.6454 -9.64166 -7.41544 0.62615 +5817 6 29.7189 5.14175 29.7003 46.1252 -36.6163 -19.9261 +5818 4 29.2969 5.47215 30.4671 -15.8461 16.6952 32.1509 +5819 4 30.5834 4.69597 30.0017 -39.473 23.5261 -13.8417 +5820 6 3.10812 21.482 2.76797 0.178067 -30.2305 -7.76436 +5821 4 2.88389 22.394 2.68207 -8.68283 21.8462 0.431797 +5822 4 2.52465 20.9987 2.15107 4.11904 7.00085 10.9335 +5823 6 13.6455 30.6616 39.7413 -31.0251 6.24286 -53.6991 +5824 4 14.4958 30.9276 39.9901 40.59 7.52955 18.7737 +5825 4 13.6028 30.9637 38.7781 -13.7388 -14.6365 40.9566 +5826 6 39.1879 23.0833 28.2631 23.8153 34.0131 -40.8644 +5827 4 39.3603 23.1915 27.276 -9.32936 -4.03115 31.7012 +5828 4 38.6771 22.3028 28.3825 -19.3689 -24.2853 3.44718 +5829 6 16.9942 23.7475 0.782551 23.2332 -11.0525 -6.02825 +5830 4 16.1835 23.4907 1.22514 -0.204047 -3.07314 3.44284 +5831 4 17.6924 23.1245 1.11262 -18.9135 18.2649 -2.71213 +5832 6 0.34625 33.6655 13.0265 -29.0282 32.855 38.2597 +5833 4 54.9333 33.1158 13.7076 7.16186 -20.0974 -8.4449 +5834 4 0.196186 34.5312 13.5136 21.864 -23.0202 -35.8666 +5835 6 49.1134 40.6592 16.9502 -22.6074 7.13526 -12.7963 +5836 4 49.0929 41.0585 16.0481 9.95068 -10.3513 11.1088 +5837 4 48.1763 40.6949 17.2078 7.5264 3.31219 -3.37923 +5838 6 52.1371 39.9932 15.179 23.5783 8.13152 6.60826 +5839 4 51.9212 40.0798 16.1068 2.92809 -1.65288 7.91558 +5840 4 51.3496 39.6649 14.7978 -27.1925 -6.99882 -20.2103 +5841 6 29.0492 37.0934 37.8397 27.862 0.580994 -15.5106 +5842 4 29.7824 36.6456 38.29 -13.83 -0.942856 -3.03347 +5843 4 28.3401 37.1923 38.4583 -14.8343 8.34268 17.6028 +5844 6 4.87483 1.47389 27.5722 8.99005 1.78018 0.412076 +5845 4 5.18955 1.04652 26.7639 -2.94161 4.65408 6.15856 +5846 4 5.65876 1.67721 28.1054 -5.69693 -0.488114 1.02013 +5847 6 43.5905 24.3648 30.2005 -22.2044 -15.6763 19.9702 +5848 4 44.3573 23.9419 29.8442 19.8319 -9.6252 -11.3654 +5849 4 42.9995 23.6287 30.4468 4.54232 11.3491 -5.57307 +5850 6 33.7546 3.53169 22.9281 6.20171 -10.3572 -20.5792 +5851 4 34.1788 2.72522 22.5548 -7.61164 22.2296 6.95503 +5852 4 33.66 4.19918 22.2026 -0.715781 -19.232 19.3758 +5853 6 19.8847 13.4579 25.4063 -13.0952 -9.58357 -31.6265 +5854 4 20.5464 14.0819 25.6574 14.0517 10.8301 14.4774 +5855 4 19.8633 12.7253 26.0209 8.35596 -5.88238 10.9252 +5856 6 47.3765 23.175 39.6238 -8.62258 12.6683 8.16714 +5857 4 47.7656 22.5263 39.0394 4.03481 -11.1372 -12.2265 +5858 4 47.7314 24.026 39.3382 2.38196 -1.35255 2.76448 +5859 6 20.1792 18.6695 32.3892 10.8118 -11.8558 9.82813 +5860 4 19.7451 19.3837 31.9609 -18.6549 15.8768 -14.4176 +5861 4 21.1063 18.8885 32.2904 5.57481 -8.22146 4.6255 +5862 6 0.469489 5.80056 25.6694 -18.1951 25.8664 -34.3154 +5863 4 0.192512 6.63022 25.2132 12.4788 -26.9708 -4.90825 +5864 4 0.599388 6.15564 26.5295 8.98284 3.20038 34.2611 +5865 6 6.87796 19.5502 31.9212 -30.9469 28.3562 -15.4034 +5866 4 6.36899 19.9719 32.666 7.94508 -11.3044 -26.1662 +5867 4 6.51823 19.9652 31.058 21.1032 -17.2362 32.6466 +5868 6 6.72006 20.2763 38.5282 -5.5716 11.964 -18.9783 +5869 4 5.89143 20.7831 38.5761 11.8801 -4.42879 -4.55199 +5870 4 6.91977 20.0675 39.4366 -2.33705 -6.77268 4.9945 +5871 6 22.0131 25.9408 12.2669 -3.54377 -45.9259 -44.7125 +5872 4 21.4169 25.4251 11.6232 6.06411 36.0021 36.1209 +5873 4 22.8575 25.5519 12.0003 5.79029 4.70211 8.19546 +5874 6 39.2956 7.94468 2.64777 3.93347 -3.54621 1.69719 +5875 4 39.6192 7.96721 3.55942 2.89932 9.4301 1.57912 +5876 4 39.5223 7.0665 2.33247 5.57505 -8.53159 -3.65477 +5877 6 29.9733 22.0379 34.4029 6.80249 8.99144 -26.5663 +5878 4 30.9486 21.9114 34.4332 -22.6925 2.47334 -4.63229 +5879 4 29.7282 22.2324 33.4511 1.23467 -5.29722 31.1857 +5880 6 37.585 16.2896 0.378862 9.66072 -32.1652 -13.4334 +5881 4 37.1738 15.3958 0.469359 7.4986 19.6703 2.82788 +5882 4 38.3979 16.0784 41.7811 -5.81955 5.34443 7.8674 +5883 6 11.7199 13.8969 21.9024 0.976022 -4.28814 -52.9061 +5884 4 11.762 13.5091 20.9636 8.25344 3.74313 41.2159 +5885 4 11.7301 13.2111 22.5694 -0.197866 -18.3587 0.721586 +5886 6 33.3547 10.9227 27.6206 7.79028 2.98821 -12.2755 +5887 4 32.7398 11.5851 27.2614 8.9286 -8.03905 3.2582 +5888 4 34.0693 10.7866 26.9485 -19.1033 10.7299 13.3482 +5889 6 30.9479 36.5351 10.0985 1.61282 -58.9885 -21.8283 +5890 4 31.0506 36.3975 9.1055 -4.33965 11.8991 35.1417 +5891 4 31.0192 35.5887 10.4601 -6.41155 39.3119 -7.26857 +5892 6 45.5784 6.55949 25.24 49.1938 -13.828 -6.30557 +5893 4 44.6777 6.5515 25.5065 -25.461 -8.09624 7.65514 +5894 4 45.978 5.64009 25.2752 -26.9592 28.1751 -0.0529727 +5895 6 9.53089 30.0259 12.0468 18.203 -29.4993 -35.3826 +5896 4 9.87965 30.5113 11.2809 1.8895 2.86193 6.03312 +5897 4 9.26134 30.6784 12.652 -18.7794 25.6859 27.1844 +5898 6 53.0787 24.9761 1.37462 5.70131 11.5656 52.3682 +5899 4 52.7701 24.171 1.02302 -14.9871 -27.078 -25.8882 +5900 4 53.2426 25.5756 0.676612 4.18045 17.0305 -26.7636 +5901 6 26.1794 24.7359 0.502901 22.1176 -25.6344 -30.1555 +5902 4 25.7034 24.7594 41.5454 1.42755 5.35042 26.0986 +5903 4 25.8798 25.3805 1.12222 -18.0425 21.9232 11.274 +5904 6 23.006 2.41877 11.549 3.03835 0.786733 -23.201 +5905 4 22.1232 2.19651 11.8728 1.75899 -1.65202 1.96434 +5906 4 22.9163 2.42328 10.5701 -3.31062 2.24291 13.1011 +5907 6 29.9286 12.8953 30.9894 2.56623 -0.427284 6.89615 +5908 4 30.7531 12.7948 31.5295 -11.6926 9.48208 -25.7239 +5909 4 30.1452 13.1242 30.0532 3.97045 -7.90132 21.6369 +5910 6 24.0654 16.1863 40.3478 -8.57837 -16.1993 -7.0618 +5911 4 23.8181 16.8167 40.9886 -17.7345 17.1107 43.7161 +5912 4 24.4461 16.799 39.7307 8.03288 -6.21636 -19.956 +5913 6 21.8775 29.9129 12.7438 8.38993 20.3936 0.69825 +5914 4 21.1101 29.6022 12.2761 -16.411 -9.00989 -4.05561 +5915 4 21.7959 30.8814 12.6689 6.66677 -10.3308 5.74649 +5916 6 45.2196 12.276 6.62528 -23.2047 44.1078 30.1736 +5917 4 45.4494 11.529 6.11864 16.0879 -27.9404 -20.133 +5918 4 45.9267 12.944 6.63915 -2.18395 -9.27911 -10.7446 +5919 6 7.59043 25.3914 38.0243 42.7544 -18.087 21.3587 +5920 4 8.2454 25.1294 37.3073 -28.6085 13.3538 22.5553 +5921 4 8.06078 25.1795 38.9036 -17.5445 13.8955 -36.9473 +5922 6 46.1702 7.81994 16.6869 -21.8749 40.0263 -11.2018 +5923 4 46.5308 7.86296 15.7811 2.96678 -6.7279 9.6444 +5924 4 46.6568 7.20863 17.2067 24.29 -27.7199 6.2944 +5925 6 54.9712 12.8519 7.72645 -5.0392 -7.84126 -11.592 +5926 4 54.9715 13.8156 7.65436 -3.45199 -1.13943 9.08655 +5927 4 54.3111 12.5688 8.37934 8.51313 12.0297 -0.864167 +5928 6 26.936 39.6495 37.1759 1.87165 14.912 18.6021 +5929 4 27.6928 39.6002 36.5592 -3.34619 -10.0228 14.3716 +5930 4 27.1866 39.3914 38.108 -0.832196 -0.678219 -33.4669 +5931 6 27.0349 8.92218 38.0169 24.6524 -2.61622 -28.7715 +5932 4 26.316 9.52058 38.1337 -23.9094 17.4181 8.51603 +5933 4 27.4852 9.31616 37.2255 -4.7843 -14.0734 18.554 +5934 6 8.05135 7.65161 29.9116 12.1299 -7.94147 21.2544 +5935 4 8.62851 7.92802 30.6495 -6.35395 -5.29094 -12.0163 +5936 4 7.74814 8.47335 29.5547 -5.2558 18.4649 -14.2469 +5937 6 27.8737 27.8565 12.1051 -38.6038 15.3188 22.9885 +5938 4 27.4445 28.7122 12.3849 14.7215 -19.9621 -4.23437 +5939 4 28.6312 28.0341 11.5799 28.6137 10.9177 -18.1106 +5940 6 23.5548 30.5037 38.1558 -29.4871 -31.9475 26.5081 +5941 4 24.0962 30.758 38.9126 3.93335 7.76671 -5.43794 +5942 4 23.9417 30.8351 37.3772 21.2145 16.4773 -23.4003 +5943 6 48.0793 24.306 17.3344 -19.3615 12.8085 -14.3801 +5944 4 47.2872 24.7421 17.7455 27.359 -7.68532 -3.4425 +5945 4 48.1537 24.7387 16.4546 -0.580236 -6.90317 13.1114 +5946 6 38.498 5.30294 40.3305 40.7021 23.5094 2.62433 +5947 4 38.9475 4.64687 39.7972 -10.9193 -18.4764 2.07144 +5948 4 39.1882 6.01706 40.3225 -28.8653 -3.92995 8.38836 +5949 6 31.2337 3.92695 33.7301 -2.6422 16.6026 -6.87478 +5950 4 31.7948 4.28658 33.0166 -2.97898 -8.44373 7.32517 +5951 4 31.5298 3.03423 33.9266 10.3473 -9.06319 -0.444766 +5952 6 41.2426 8.81864 38.1104 -4.47266 -7.82466 24.3448 +5953 4 41.0373 8.41451 38.9755 -2.01902 1.52645 -10.1427 +5954 4 41.1368 9.75783 38.3095 7.23604 3.04516 -5.74389 +5955 6 53.3619 29.0937 24.5785 -40.2757 11.297 7.14485 +5956 4 52.5565 28.5537 24.7901 26.871 10.2044 -0.818821 +5957 4 52.9453 29.9599 24.3491 20.4755 -15.9472 -3.03 +5958 6 54.9044 15.544 40.7081 25.545 -57.3548 17.1629 +5959 4 54.9892 16.405 40.3633 -12.4948 43.2864 -12.4113 +5960 4 54.018 15.2891 40.9908 -7.57666 14.2468 -5.0348 +5961 6 46.3994 17.0672 31.8767 -6.245 16.1286 -17.5712 +5962 4 46.5114 17.9797 31.5283 3.34232 -11.2714 9.55259 +5963 4 45.8128 16.6602 31.1996 2.74349 5.02824 21.6551 +5964 6 36.898 25.0477 23.0493 11.3229 21.4084 -39.4528 +5965 4 37.2029 24.9737 23.9235 7.13326 -1.42781 43.2733 +5966 4 36.3025 24.3424 22.8486 -15.8402 -9.5757 6.36085 +5967 6 11.3692 4.41343 15.9249 15.7896 22.4119 -17.7964 +5968 4 11.3725 3.62473 15.3598 -3.28732 1.6252 14.2587 +5969 4 11.7055 5.11941 15.3214 -6.01385 -9.48847 12.8461 +5970 6 12.7845 7.07125 19.464 -10.6801 6.56169 22.7508 +5971 4 12.8604 6.27981 18.9655 14.1597 -21.8558 -24.6024 +5972 4 12.2771 6.71627 20.2197 6.8185 19.6013 -8.61559 +5973 6 12.0681 33.6471 17.5522 -1.52085 -17.496 -42.1785 +5974 4 11.9445 34.1189 18.3508 -6.25092 12.897 34.2466 +5975 4 12.5251 32.8183 17.7704 2.9394 6.95993 4.68875 +5976 6 10.2419 4.74292 2.55933 22.7613 10.361 1.71337 +5977 4 9.42389 4.50476 2.9876 -9.73314 -9.75152 7.74431 +5978 4 10.9687 4.12007 2.82053 -14.8261 2.90481 -11.2179 +5979 6 4.58785 36.8771 12.1606 -7.79451 -50.5455 -28.0593 +5980 4 4.4315 37.6675 12.6216 -0.588552 45.9766 17.7929 +5981 4 5.40236 36.9214 11.6472 0.781205 5.58305 7.99313 +5982 6 30.7591 35.3322 25.8391 -38.6972 -6.70904 -25.8809 +5983 4 31.308 35.3014 26.6139 2.09136 -3.6723 11.5509 +5984 4 29.8922 34.8696 26.0006 25.0535 4.09477 3.57125 +5985 6 20.1826 7.15897 1.87495 42.3449 13.1453 -15.8992 +5986 4 20.9155 6.54161 2.14653 -26.0098 16.5163 -6.36728 +5987 4 20.7109 7.92751 1.4772 -24.8109 -25.5601 12.7141 +5988 6 21.7554 6.89613 28.9929 -8.55274 -2.37394 -9.1913 +5989 4 22.0764 7.2366 29.8207 3.60587 3.07422 19.5812 +5990 4 22.5251 6.52709 28.5653 7.82832 -0.878326 -6.51175 +5991 6 6.87782 37.1389 6.94163 -1.13334 10.8563 13.3375 +5992 4 7.36847 37.9928 6.7949 -15.2779 -15.8129 7.53623 +5993 4 6.56156 37.0941 7.87645 12.8328 8.43507 -22.3513 +5994 6 37.1951 18.3599 16.3051 31.8484 54.3956 -63.0636 +5995 4 36.5686 18.6502 16.9278 -28.3708 4.63663 38.6073 +5996 4 37.3394 19.2548 15.8115 -3.93301 -42.965 18.1753 +5997 6 52.3874 25.498 31.3134 14.111 8.09505 3.74503 +5998 4 52.2596 26.4307 31.6656 16.8187 -33.1452 -9.3176 +5999 4 53.3531 25.244 31.2999 -24.6813 13.8962 6.4969 +6000 6 3.93514 39.8328 16.38 27.5969 -10.0907 -6.6773 +6001 4 3.11618 39.8354 16.8714 -5.56329 -11.6849 3.14974 +6002 4 4.25813 38.8985 16.2148 -16.7217 35.1377 3.93655 +6003 6 26.055 14.6352 18.3097 2.48745 23.0231 -5.4837 +6004 4 27.0121 14.5315 18.422 -4.58232 5.3017 0.111087 +6005 4 25.8831 15.6122 18.2324 0.591934 -25.1482 1.36918 +6006 6 22.1861 39.625 23.6336 -13.0035 -7.16992 22.0669 +6007 4 22.5756 40.4198 23.3178 20.0241 20.7615 -16.9022 +6008 4 21.775 39.9577 24.4575 2.36146 -17.5943 -7.81238 +6009 6 5.9827 12.8747 22.3739 5.28791 3.19174 -0.347139 +6010 4 6.16079 13.1981 21.4813 -0.557605 -0.80783 -0.954564 +6011 4 6.85402 12.6686 22.7296 5.64669 -4.60509 -1.11135 +6012 6 48.9358 28.1656 34.7093 -34.12 -15.1013 -7.57113 +6013 4 48.3009 27.4712 34.4428 -1.24475 21.7165 7.07681 +6014 4 49.7483 27.6911 34.6564 33.1581 1.27133 3.59264 +6015 6 7.76665 22.4378 33.2356 5.82113 4.36953 2.134 +6016 4 7.99414 22.0593 34.0982 -2.05459 -3.4103 -7.93698 +6017 4 7.15982 21.8587 32.7652 -2.05153 -2.03416 7.79212 +6018 6 41.0903 39.5994 11.7192 28.8485 25.6095 5.96672 +6019 4 40.6961 40.3697 11.3388 -29.9964 5.48828 -17.7316 +6020 4 41.854 40.0697 12.1081 -2.33823 -21.5528 5.66509 +6021 6 26.8801 37.922 39.3457 -9.67122 -13.15 30.7983 +6022 4 27.1418 37.9976 40.2903 -3.7646 7.48977 -14.0985 +6023 4 25.9915 37.5069 39.4007 11.6973 7.1772 -10.1587 +6024 6 16.8317 41.5399 16.7862 15.0313 6.40425 17.7164 +6025 4 17.5506 0.178386 16.4567 -5.24562 -1.69226 -13.3924 +6026 4 17.0965 41.4441 17.7156 -14.9292 -9.12078 -7.2801 +6027 6 19.02 8.9948 17.6728 1.01249 -20.0254 27.6053 +6028 4 18.8256 9.92734 17.8397 -2.50665 -0.780218 3.94781 +6029 4 19.0722 8.45531 18.5284 1.63313 22.2167 -34.6872 +6030 6 31.0993 24.379 20.1031 -5.45136 7.30173 -0.0135243 +6031 4 30.58 24.6604 20.88 7.69136 -4.59203 -13.2888 +6032 4 31.7465 25.0718 19.9526 0.652083 2.88804 -0.364555 +6033 6 24.6121 6.3117 27.596 -14.2942 3.47042 8.51555 +6034 4 24.6855 6.72112 26.7154 0.000835906 -11.6728 3.52597 +6035 4 24.4562 5.35726 27.5796 2.29956 0.742888 -9.80031 +6036 6 11.6309 5.33579 8.21245 48.3472 17.5789 -13.0214 +6037 4 10.7447 5.097 8.35577 -43.9811 -8.24091 9.59422 +6038 4 11.6324 6.14291 7.66014 -5.62825 -15.0071 6.92232 +6039 6 16.4828 34.2339 17.2467 58.9453 43.3211 -11.1422 +6040 4 15.833 34.737 16.7643 -22.9367 -4.06405 -2.05249 +6041 4 17.323 34.8225 17.0684 -41.083 -49.3458 15.3182 +6042 6 40.7431 40.4645 8.52128 12.2314 -11.8005 -21.5431 +6043 4 40.0246 40.6751 9.09883 -14.9736 5.2464 12.3608 +6044 4 40.4244 39.6664 8.05294 5.87539 10.603 6.78918 +6045 6 42.7463 5.87875 14.2877 12.74 -3.29305 -3.26541 +6046 4 42.0588 5.87807 14.9272 -15.1719 8.11415 20.4154 +6047 4 42.5132 5.11812 13.7588 -0.0411089 -3.23222 -11.0769 +6048 6 14.3659 21.065 6.06718 -46.5802 14.1632 25.7131 +6049 4 14.5381 21.6726 6.80844 -4.55135 -9.99097 -5.53618 +6050 4 15.2049 20.8313 5.76105 45.2018 -10.2131 -22.6687 +6051 6 16.2987 37.772 18.1217 -43.41 26.7654 24.2454 +6052 4 15.4242 38.2299 18.3727 36.2216 -25.3097 -28.3843 +6053 4 16.6845 37.7048 19.001 13.5629 -5.49997 -6.41318 +6054 6 40.7915 27.7152 27.1158 9.45156 2.81801 -4.91689 +6055 4 41.5456 27.319 27.566 -3.53201 -5.16081 10.0516 +6056 4 41.2155 28.2976 26.4751 -4.07016 3.79859 -1.40954 +6057 6 44.9595 25.9846 14.0499 3.3218 -15.4841 -8.79479 +6058 4 45.329 25.1566 13.6433 -5.22711 26.2877 13.1546 +6059 4 45.4837 26.7406 13.7529 4.37393 -9.76715 -6.45081 +6060 6 2.62066 33.9505 21.2427 -16.9582 -3.86849 -3.69815 +6061 4 2.06211 34.7496 21.3041 9.37305 -3.74186 4.79914 +6062 4 2.1388 33.3568 20.6382 5.47892 10.3925 4.65279 +6063 6 5.77806 4.43691 12.8378 4.70319 28.9306 -8.8144 +6064 4 5.36233 3.72198 13.3221 -5.81749 -8.58488 4.20714 +6065 4 5.80863 5.24637 13.3804 -1.3041 -13.5761 2.8333 +6066 6 16.8665 5.92021 7.40582 23.56 -3.08178 3.03829 +6067 4 16.4354 5.08697 7.20958 -2.89912 -12.7512 -7.28137 +6068 4 16.1638 6.54304 7.4701 -21.737 13.5702 4.65232 +6069 6 17.8259 38.4084 36.8446 -8.45971 28.6621 19.1884 +6070 4 17.7005 39.3712 37.0468 11.155 -18.7052 -15.1769 +6071 4 18.5325 38.3077 36.2071 4.43545 2.51623 -4.89916 +6072 6 43.3084 20.5973 5.4325 -39.7754 20.35 -2.23031 +6073 4 43.0204 21.5105 5.15286 19.9417 -23.843 3.70329 +6074 4 42.4274 20.1471 5.43024 22.0601 -2.53082 1.71294 +6075 6 21.5318 23.3 30.4444 10.3709 20.0389 -42.3415 +6076 4 21.0369 22.9394 31.1576 -20.9289 -4.03021 22.2109 +6077 4 20.911 23.6578 29.7428 10.7798 -15.246 22.7192 +6078 6 0.249866 28.0345 36.1724 -10.1983 37.6035 -27.6546 +6079 4 1.05324 27.7572 36.576 20.3102 -14.8665 16.9966 +6080 4 0.540234 28.832 35.6712 -10.982 -12.5736 6.41543 +6081 6 3.04754 17.0516 11.5683 -6.97145 7.64509 -15.3824 +6082 4 3.16434 17.3061 12.4746 3.36597 -0.550097 20.9912 +6083 4 2.52404 17.7798 11.2137 2.91457 -3.72579 -4.7217 +6084 6 24.1788 37.0366 23.9551 -12.9856 4.64226 12.2764 +6085 4 23.6099 37.826 23.831 6.85326 -8.75197 5.00341 +6086 4 24.4012 36.9865 24.9175 -1.53567 3.17074 -21.6248 +6087 6 3.95494 20.5134 27.4915 2.8093 53.7214 17.1103 +6088 4 3.58105 20.0931 26.7551 -14.7022 -26.8908 -38.8522 +6089 4 3.8118 21.4686 27.2477 5.25372 -20.6261 11.8203 +6090 6 54.8404 2.77723 29.6182 19.2518 19.5174 31.7291 +6091 4 54.8688 2.43537 30.559 -2.71579 12.5717 -24.6672 +6092 4 0.596183 3.44189 29.5911 -17.1059 -25.2514 0.407437 +6093 6 27.1931 8.41834 31.7378 -5.45838 77.4793 -29.1542 +6094 4 26.7872 8.25949 30.8671 -2.01983 -12.8877 1.93898 +6095 4 27.4107 9.43311 31.6496 -7.24897 -56.0438 21.5563 +6096 6 30.967 1.65521 30.3853 -24.4372 0.252197 19.6085 +6097 4 30.699 0.824835 30.0215 -2.04196 -23.8902 -26.6583 +6098 4 30.1085 1.94064 30.7387 6.28416 6.26069 6.0985 +6099 6 26.4053 36.4472 36.8445 23.7132 4.61357 6.55265 +6100 4 26.2095 35.8808 36.1068 -5.45287 -5.64468 -12.8873 +6101 4 27.3732 36.593 36.8324 -14.4493 2.44748 -3.93886 +6102 6 51.2993 10.0458 21.7014 24.6671 -30.2423 2.93053 +6103 4 50.7417 9.318 22.0589 9.26734 22.884 -6.07289 +6104 4 52.1551 9.59094 21.4448 -31.6711 18.7199 5.84467 +6105 6 52.4308 12.3792 23.2584 -6.42579 27.1004 22.8118 +6106 4 51.6946 13.0394 23.3088 16.6887 -7.91574 -6.77392 +6107 4 52.0327 11.5757 22.9611 -11.4365 -20.1199 -14.9439 +6108 6 9.99751 38.3699 20.6117 28.0449 -1.18219 -11.795 +6109 4 9.42862 38.2366 21.3654 -6.81781 0.619005 12.6857 +6110 4 10.9196 38.1916 20.8926 -11.789 -1.89114 -3.31064 +6111 6 22.7111 33.2651 0.632604 -8.26324 25.0772 17.5737 +6112 4 23.6702 33.3984 0.628432 0.752102 -10.2993 -4.51528 +6113 4 22.4939 32.4115 0.275412 2.14165 -18.6843 -11.1325 +6114 6 14.0859 40.8716 25.4956 -8.46488 1.55142 -11.4693 +6115 4 14.0599 40.7138 26.4427 12.1567 0.227551 5.06398 +6116 4 13.2623 40.45 25.1949 6.8133 8.32038 -2.55804 +6117 6 42.7734 15.0947 14.9538 14.4784 5.50426 -3.8277 +6118 4 43.0583 15.7694 14.2817 -8.42225 -24.0175 22.033 +6119 4 41.8405 15.2241 15.1238 -9.70916 3.613 0.791575 +6120 6 30.2327 7.231 8.54228 -3.22532 10.2874 -46.9304 +6121 4 30.2058 8.2102 8.45082 -0.363858 -13.9116 11.7844 +6122 4 30.4404 6.92219 9.39771 6.32383 2.81905 38.5597 +6123 6 3.37293 19.847 41.3038 28.0406 -0.792001 0.268463 +6124 4 3.19157 19.2836 40.5407 -0.0866071 4.98821 -2.30354 +6125 4 4.34764 20.0104 41.227 -24.6382 -4.50526 4.46777 +6126 6 8.87233 25.1482 17.2024 12.9182 -25.3276 -29.7935 +6127 4 8.99656 24.7585 16.2934 -10.9438 23.5455 20.5923 +6128 4 9.70028 24.8859 17.6216 -4.47076 0.166054 9.91948 +6129 6 9.34357 14.9539 22.0324 -26.1912 3.45279 3.87325 +6130 4 9.00509 14.8035 22.9321 4.97494 4.93375 -7.4516 +6131 4 10.1685 14.4775 21.9786 8.71262 0.391972 2.49596 +6132 6 2.03472 4.77693 20.8549 -5.0231 -16.4156 -4.2241 +6133 4 2.70086 5.4497 20.9192 18.9425 7.91266 2.94425 +6134 4 1.28907 5.15394 21.3146 -15.2358 3.90158 4.43282 +6135 6 18.286 7.04631 3.85489 -3.97091 0.415968 51.7005 +6136 4 18.7541 7.10917 3.04736 31.918 9.65669 -29.8899 +6137 4 18.8529 6.48913 4.44789 -12.6499 14.6692 -9.5202 +6138 6 17.0004 19.1661 19.8445 11.8294 -6.56912 -12.2376 +6139 4 17.7808 18.891 19.3473 0.445698 5.6808 3.33406 +6140 4 16.3387 18.5282 19.5337 -1.78106 12.0244 12.6463 +6141 6 4.30992 6.55322 21.357 27.1319 -4.11604 -15.0588 +6142 4 4.37542 6.91771 20.4543 -7.8574 5.76294 11.3657 +6143 4 5.24976 6.29093 21.5457 -28.1422 4.34799 0.417434 +6144 6 20.7778 36.9247 35.6618 12.7574 4.02765 2.49936 +6145 4 20.2864 37.0887 34.8562 -7.2468 0.0429553 -2.15645 +6146 4 20.2346 36.372 36.2389 -2.87094 1.27188 3.61263 +6147 6 4.73067 15.0203 31.2359 -10.2649 -12.7571 22.9725 +6148 4 4.37694 14.8342 32.1428 11.1861 -2.73027 -21.4712 +6149 4 4.72677 15.9733 31.1768 1.84417 11.2425 -7.2724 +6150 6 2.35535 1.23403 17.5726 17.2813 12.9738 -21.7174 +6151 4 3.03402 1.36527 16.8495 -17.2186 -13.1695 22.3246 +6152 4 1.92973 2.10387 17.6452 0.590267 -7.80147 9.6411 +6153 6 34.6252 31.5686 19.7984 -1.60729 -4.66139 0.568696 +6154 4 34.8929 31.9422 18.9439 4.49305 -5.18782 4.12596 +6155 4 34.4714 32.3271 20.3758 -2.9002 2.23803 -3.07041 +6156 6 24.1913 21.6089 13.5036 44.4004 0.328862 15.9674 +6157 4 25.0757 21.8297 13.9142 -30.8821 -6.11275 -18.7564 +6158 4 23.5519 22.0563 14.035 -11.4749 15.2668 7.23318 +6159 6 37.218 41.0972 5.69166 19.5034 -37.5651 -15.7416 +6160 4 37.88 41.7374 5.923 7.59407 13.6828 5.23653 +6161 4 36.3807 41.3769 5.99879 -24.6171 21.3167 5.70938 +6162 6 8.42841 7.99247 20.2345 27.9918 -33.0924 -23.0682 +6163 4 9.34968 8.06233 20.5347 -4.8675 5.92304 8.61954 +6164 4 7.93058 8.66586 20.633 -20.9635 39.4709 23.1164 +6165 6 14.934 18.8758 36.75 17.7625 18.3313 11.0559 +6166 4 14.0949 19.1945 36.41 0.856939 4.31409 -3.77921 +6167 4 15.6034 19.6084 36.7133 -18.5855 -12.9909 -4.44137 +6168 6 43.9791 40.6449 18.6524 7.41508 -0.428335 24.9958 +6169 4 43.9624 40.7544 17.7052 -3.16787 6.2189 -16.8328 +6170 4 44.8981 40.8188 18.9384 -9.62798 -9.77666 -5.30663 +6171 6 33.7986 32.259 37.3472 -15.5926 9.65631 -28.1821 +6172 4 34.0274 32.2295 36.4014 -5.19534 3.83485 15.8105 +6173 4 34.1945 31.4931 37.7276 18.2887 -12.3889 13.4194 +6174 6 5.09973 29.2834 24.0252 13.8314 -2.01249 29.2407 +6175 4 5.66693 29.5091 24.8044 -5.06459 -6.54793 -18.8628 +6176 4 4.76417 30.1245 23.7257 -5.49348 12.2693 -6.11875 +6177 6 33.6015 36.4179 10.971 30.294 2.53226 6.78363 +6178 4 32.7735 36.2836 10.5343 -15.5054 6.45725 -2.01925 +6179 4 33.4383 36.5424 11.9099 -7.56878 -2.98124 3.33663 +6180 6 28.3001 33.6166 13.1114 -3.16981 -41.1231 7.22112 +6181 4 27.986 33.7275 12.219 -4.10441 9.98298 -8.29397 +6182 4 28.0891 32.6746 13.2632 10.0083 14.4728 2.55385 +6183 6 6.1623 19.0624 24.2873 5.31394 -11.2621 -36.8053 +6184 4 5.95503 19.8074 24.8143 -4.51254 28.8134 22.7686 +6185 4 6.28788 18.3114 24.8476 4.1007 -18.6743 20.2695 +6186 6 28.4211 19.9362 1.86305 -4.43245 7.71948 8.08869 +6187 4 28.5604 19.4518 1.05094 6.94613 -11.0067 -8.65768 +6188 4 29.2593 20.0693 2.30859 5.46778 1.78077 -4.74455 +6189 6 42.0505 23.9714 9.55892 6.22877 26.0941 -5.00732 +6190 4 42.391 23.8165 10.4395 -2.03908 -8.00084 11.8727 +6191 4 41.7886 23.1541 9.15249 -7.7641 -22.6922 2.79783 +6192 6 43.5253 7.315 27.4414 4.48568 -18.9578 -0.168547 +6193 4 42.7359 7.07504 27.9388 -6.2009 1.74131 6.88183 +6194 4 43.2052 7.88335 26.7439 -2.31843 16.2411 -9.46916 +6195 6 20.4956 32.9945 9.25625 -63.2008 -2.41398 62.3431 +6196 4 19.7614 32.7323 9.96384 46.0698 -1.29529 -42.5223 +6197 4 20.3338 33.9485 9.24422 8.88758 3.29294 -12.4302 +6198 6 38.0318 35.2729 15.9427 -5.10059 -23.3836 -5.94715 +6199 4 37.3995 34.9842 15.2568 2.89047 3.01243 8.00796 +6200 4 37.9835 34.6007 16.6396 -2.13864 4.37071 -5.14357 +6201 6 47.5248 20.8808 3.95546 13.1177 31.1209 27.8573 +6202 4 48.0834 21.3954 3.36869 -6.69878 -8.89675 -13.1919 +6203 4 47.6052 21.4353 4.7772 -13.2785 -23.1226 -13.8569 +6204 6 10.9875 31.6892 41.4239 15.5099 5.40423 7.74084 +6205 4 11.658 31.8708 40.7529 -4.12469 -5.30401 -0.84079 +6206 4 10.1343 31.6927 40.9879 -7.96504 0.77506 -5.12071 +6207 6 43.245 12.6563 2.56138 15.9633 -17.8577 -2.60545 +6208 4 42.9226 12.9752 3.38765 -12.1061 12.2594 19.7928 +6209 4 43.9805 12.0851 2.8659 -6.2276 8.95994 -12.8364 +6210 6 49.4104 25.4124 21.1593 7.68799 -7.2912 5.83542 +6211 4 50.1422 25.2884 20.5387 -8.96396 0.548785 -4.3756 +6212 4 48.9554 24.5515 21.2297 -0.219253 8.20777 -2.75058 +6213 6 1.96484 34.1377 26.4635 6.42117 -7.58108 12.8955 +6214 4 2.78995 33.6488 26.6876 -20.6965 7.00883 -11.752 +6215 4 1.22498 33.5087 26.4121 8.61724 -1.18295 0.134997 +6216 6 17.1337 20.8362 36.6743 -37.6695 15.6036 21.8376 +6217 4 16.9634 21.7284 37.0778 2.65776 -21.0237 -14.9647 +6218 4 18.0617 20.7108 36.604 32.6572 -5.60583 -3.13187 +6219 6 36.5992 10.9735 3.70439 10.6975 8.82737 -5.2901 +6220 4 35.7369 11.4094 3.76988 -2.71865 -0.136466 14.5734 +6221 4 36.9547 10.7712 4.57736 -11.0261 -1.49358 9.11508 +6222 6 14.2213 20.6732 21.973 14.9521 39.3927 -42.8738 +6223 4 13.9206 20.2439 21.1689 -11.1282 -8.72354 1.45028 +6224 4 14.6851 21.4628 21.5779 -7.13343 -24.0966 22.8635 +6225 6 33.9052 12.2539 9.56536 64.6676 -19.1083 -72.943 +6226 4 34.3898 11.482 9.88615 -11.1791 5.59008 13.1859 +6227 4 33.2619 12.5422 10.1406 -48.1209 12.4396 55.8498 +6228 6 21.8075 41.4938 2.15247 -4.53434 0.170379 -15.7872 +6229 4 22.04 41.6038 1.2069 -3.47083 0.972349 16.0219 +6230 4 22.4007 40.8419 2.51679 12.4955 -1.6466 3.58022 +6231 6 20.9241 10.4413 14.2084 23.7182 11.537 17.3335 +6232 4 21.6155 10.8692 14.7979 -25.0251 -17.572 -17.464 +6233 4 20.772 9.54041 14.5736 6.4121 16.6732 -7.22543 +6234 6 6.25992 4.45494 24.6446 -20.993 10.5392 9.58783 +6235 4 6.70633 4.20365 23.8452 17.869 -10.7134 -15.0213 +6236 4 5.71116 3.71075 24.9084 -2.77077 -5.20552 -8.90983 +6237 6 50.776 14.5967 23.4784 31.7068 8.96229 10.5861 +6238 4 51.3012 15.0259 24.1918 -10.5702 -1.89466 -14.6802 +6239 4 49.902 14.4731 23.8252 -15.4415 -8.6063 7.51113 +6240 6 52.7906 13.9066 9.67243 -4.11462 48.2741 -4.64476 +6241 4 52.8606 13.0389 9.99278 3.823 -46.6932 12.5875 +6242 4 51.8698 14.0585 9.47707 -15.983 -0.946523 -10.048 +6243 6 9.04475 2.0467 29.9184 -38.5307 -30.621 -19.1189 +6244 4 9.46565 2.82007 30.2002 17.3321 39.2201 17.0183 +6245 4 8.08016 2.26538 29.8177 25.0495 -3.86709 2.38687 +6246 6 7.14389 29.9898 26.2407 4.70582 -42.771 12.4286 +6247 4 6.53112 30.404 26.8495 -5.08686 4.52864 3.1398 +6248 4 7.41427 29.1442 26.7142 -2.42767 26.6911 -17.7681 +6249 6 49.1638 41.7413 14.3375 -4.64089 27.4779 2.19815 +6250 4 49.5241 41.3828 13.5134 1.94418 -6.50091 1.47491 +6251 4 49.3811 0.802946 14.3236 2.14399 -30.2019 -5.07663 +6252 6 5.64888 3.82667 19.1906 -2.72189 -11.1411 26.1263 +6253 4 5.18678 3.36179 19.9258 5.23606 10.5823 -14.7259 +6254 4 5.05621 3.82399 18.4509 -7.60985 1.79477 -11.7277 +6255 6 9.32681 35.8274 24.8975 3.55565 13.5922 8.51546 +6256 4 10.2018 35.8152 24.4762 -3.06017 -4.39849 2.56743 +6257 4 9.46171 36.417 25.6586 -3.66837 1.49938 -3.23358 +6258 6 53.0285 29.7558 11.5499 -7.83487 -2.48558 9.64451 +6259 4 53.3653 30.4407 10.9686 7.5475 4.44921 -4.95089 +6260 4 52.7971 30.2083 12.3783 3.5824 -3.07517 -4.75195 +6261 6 22.6104 9.96627 5.67467 11.8622 1.90434 48.3765 +6262 4 23.3836 10.3266 6.15809 -8.36646 -10.9093 -7.81297 +6263 4 22.6398 10.3769 4.83333 -6.21393 7.91547 -32.804 +6264 6 39.5293 19.6134 2.67969 28.3515 9.20962 14.5311 +6265 4 38.5781 19.5068 2.58618 5.24604 -11.8744 -9.9137 +6266 4 40.0367 19.3939 1.87869 -17.6459 -1.04308 -3.70363 +6267 6 45.0742 35.5802 7.80399 12.9966 -1.00157 -13.6899 +6268 4 45.1073 36.2582 8.46111 4.45786 22.5875 10.9896 +6269 4 44.5296 34.9182 8.21469 -15.7495 -15.8794 0.100297 +6270 6 29.7829 14.2459 9.96531 -11.2509 -10.5838 -6.95263 +6271 4 30.0063 14.1556 9.0247 4.7074 -2.26926 1.20969 +6272 4 28.8478 13.9409 10.004 20.3358 11.6689 4.42407 +6273 6 29.2532 30.1489 21.8872 -22.7358 8.41186 19.7293 +6274 4 29.1261 30.8351 21.2312 3.02893 4.58934 -9.48892 +6275 4 30.0577 29.6729 21.7506 17.9631 -9.68935 -13.2514 +6276 6 11.1028 18.8149 6.56446 12.6172 11.1172 -5.75863 +6277 4 11.2898 19.7306 6.3073 -12.9819 2.38317 -1.53669 +6278 4 11.9922 18.4416 6.57196 0.724871 -8.7617 2.86424 +6279 6 13.403 39.1446 13.4748 19.5871 -11.9429 -30.0571 +6280 4 13.7697 39.8507 13.9939 7.8117 10.5151 13.4831 +6281 4 12.6292 38.8582 13.9386 -20.2152 -7.12839 8.32373 +6282 6 50.1432 12.9893 0.138872 33.4511 24.3017 64.4039 +6283 4 49.8497 12.6921 41.2405 -20.6967 -26.8999 -59.7452 +6284 4 50.7523 12.3231 0.503203 -9.52656 2.062 -3.94446 +6285 6 47.8312 31.3446 27.7846 -28.8076 12.8422 -13.2841 +6286 4 47.8833 31.94 28.5222 10.4006 4.03183 17.8143 +6287 4 46.9755 31.6479 27.4044 17.0933 -18.1054 -4.43643 +6288 6 27.7087 1.63781 7.50008 21.5285 -7.57238 -25.6841 +6289 4 26.9556 1.59549 8.05597 -25.0455 5.22958 17.9803 +6290 4 27.5166 0.963037 6.82134 -2.90509 7.89899 -0.0646572 +6291 6 54.8922 20.8 16.0331 4.1789 -41.4982 -7.93337 +6292 4 54.9282 20.9554 16.9716 0.186425 8.83729 15.9831 +6293 4 0.211633 19.8495 15.948 -9.91253 29.0383 -5.43741 +6294 6 37.4291 33.0056 34.4398 -14.0977 10.8622 -7.94924 +6295 4 37.2978 32.0826 34.6133 -1.58878 -21.6351 7.1631 +6296 4 36.5764 33.2755 34.0173 17.7258 4.45123 10.3439 +6297 6 19.5104 39.7742 6.7506 5.90241 -38.4201 -4.61078 +6298 4 19.1293 39.2182 6.01225 10.8403 19.9531 16.5545 +6299 4 19.9162 39.0938 7.35425 -12.9804 24.3225 -11.3083 +6300 6 32.4399 2.72699 8.06906 17.0773 23.4006 1.78158 +6301 4 32.9347 3.14941 8.81642 -19.9733 -16.2934 -9.37408 +6302 4 31.5531 2.49842 8.37658 0.516726 -6.41942 5.39598 +6303 6 12.9757 16.0915 4.06618 3.48233 -26.1302 -11.2272 +6304 4 12.5744 15.6527 4.83433 -0.695682 4.00385 -3.98901 +6305 4 13.3513 15.3473 3.55621 -4.30287 11.2057 5.6128 +6306 6 4.64677 29.9233 5.42983 -10.8182 14.2385 -56.8973 +6307 4 4.99957 30.1958 4.52107 -6.90737 -7.02982 36.161 +6308 4 3.86081 29.3683 5.18005 29.0195 11.7205 17.0104 +6309 6 29.7541 32.1122 24.0662 13.5325 13.0696 7.67536 +6310 4 30.657 32.2311 24.4313 -14.6232 -5.62961 -5.85099 +6311 4 29.8358 31.5529 23.3009 -2.99915 -14.1964 -7.88188 +6312 6 11.8689 30.6971 33.4711 -8.01032 -39.2081 28.7873 +6313 4 11.8961 29.8478 34.0479 -0.904256 41.1124 -29.4381 +6314 4 12.7288 30.7703 33.0546 6.62137 -3.78113 1.33903 +6315 6 17.3676 40.4123 27.3051 45.9752 30.8726 -27.1152 +6316 4 17.3095 41.3718 27.4557 -2.78012 -6.90788 -0.219066 +6317 4 16.6513 39.9873 27.6906 -54.0346 -15.2197 27.4879 +6318 6 8.66734 4.89901 8.93063 6.14116 -5.58058 -4.6479 +6319 4 8.35347 5.40804 8.18272 -1.2331 1.82325 -6.13974 +6320 4 8.16334 5.22925 9.67691 0.199365 1.34734 7.84993 +6321 6 39.5604 17.6833 9.57201 22.5105 -50.1639 -23.667 +6322 4 39.2658 17.6048 10.464 -10.5204 8.51393 23.2154 +6323 4 39.725 16.7168 9.31019 -10.6666 45.7312 -1.86495 +6324 6 31.4955 30.1755 28.5516 10.628 -19.507 17.1882 +6325 4 32.3525 30.3948 28.1778 -6.71462 8.32315 -8.11857 +6326 4 31.74 29.3729 29.0438 -14.9082 5.37925 -0.357203 +6327 6 52.6685 19.2672 40.0663 9.25056 16.4026 -20.0757 +6328 4 53.0106 18.7322 39.321 -9.61724 -4.6138 17.4516 +6329 4 53.0677 20.1385 39.8955 -5.74465 0.792691 -1.74468 +6330 6 3.24164 7.81666 9.85998 28.0429 9.66948 1.15728 +6331 4 3.83019 8.53432 10.2304 -23.9275 -17.8293 -12.7584 +6332 4 3.84853 7.29279 9.3074 -9.38214 5.4782 3.90821 +6333 6 23.129 35.218 35.5945 -25.4929 1.01472 15.9258 +6334 4 23.7784 35.3391 34.9359 33.2897 3.00284 -24.4901 +6335 4 22.5015 35.9398 35.4197 -4.85807 -5.03855 8.29984 +6336 6 19.51 14.0653 20.8221 -35.7596 -3.44758 -1.61502 +6337 4 19.8587 14.4985 21.6011 13.4146 6.44294 7.16022 +6338 4 18.5274 14.0852 20.9637 18.4505 -1.93413 -5.69736 +6339 6 23.6205 15.8624 24.0207 6.44012 -27.6666 -1.73497 +6340 4 23.7023 16.8084 24.0387 5.71305 22.1977 -2.17526 +6341 4 24.4604 15.4749 23.6823 -15.4387 15.2983 3.34328 +6342 6 0.280487 30.496 6.10097 2.10248 14.5258 38.6463 +6343 4 54.969 30.1752 5.28655 -5.78718 -18.1599 -43.8305 +6344 4 54.4568 30.8162 6.51538 2.11893 2.60892 6.09244 +6345 6 4.88818 13.213 29.1211 -10.1066 -44.834 -24.7823 +6346 4 4.81121 13.8494 29.7943 -5.77674 34.7781 35.8081 +6347 4 5.65875 13.4519 28.6173 14.302 5.76116 -10.624 +6348 6 54.2113 27.2762 19.1921 -15.5686 -30.3542 31.9917 +6349 4 0.068746 27.3681 19.6083 11.8738 0.793184 4.88761 +6350 4 54.2438 27.8077 18.4285 0.565084 22.1088 -37.313 +6351 6 13.9147 35.7477 9.19539 -9.45761 -42.0549 -30.4782 +6352 4 13.6498 35.0288 8.53341 12.0253 23.1831 27.3793 +6353 4 13.9217 36.5134 8.63033 3.91359 16.7787 -6.83247 +6354 6 5.91895 31.9062 18.8199 -10.5522 26.6577 -12.1166 +6355 4 5.59368 32.8276 18.7738 -3.70357 -9.82177 15.0022 +6356 4 6.3357 31.8271 17.9661 5.53766 -12.0386 -9.76018 +6357 6 5.80079 28.8629 9.48582 -4.23387 2.66619 -7.91216 +6358 4 5.1492 29.3316 10.0156 -4.194 3.81529 3.65919 +6359 4 5.26808 28.2356 8.96551 5.75879 5.11243 0.385299 +6360 6 40.1186 6.06288 9.7252 27.6823 -14.9678 -34.8134 +6361 4 40.0604 6.61837 8.91786 -4.97866 -6.72317 19.9534 +6362 4 40.8451 5.41953 9.46609 -26.5422 19.2978 14.9684 +6363 6 20.3249 13.4665 41.4109 48.5393 0.491453 -34.6424 +6364 4 21.248 13.7047 41.7262 -35.6043 -9.97545 -2.58991 +6365 4 20.4078 13.625 40.4256 -17.6073 -2.89865 23.6593 +6366 6 14.4355 21.7431 27.3521 26.8888 -5.93952 12.1752 +6367 4 15.3929 21.7238 27.5426 -15.4302 4.65814 3.66232 +6368 4 14.4086 21.5632 26.4128 -6.38145 3.02673 -3.91912 +6369 6 38.7552 1.80385 30.0529 11.0268 -28.3612 -27.359 +6370 4 38.4475 1.96331 30.9218 -11.1335 10.8767 32.3314 +6371 4 38.864 2.66369 29.6567 5.01485 14.1269 -3.82072 +6372 6 5.6038 10.8537 14.1812 -8.02182 -19.6512 10.0037 +6373 4 4.967 11.5707 14.1035 -3.71772 1.30399 -2.93081 +6374 4 5.11243 10.0991 14.6 11.6474 17.9462 -13.8385 +6375 6 45.4185 36.7135 27.9228 -18.8199 18.417 -42.2307 +6376 4 46.0687 36.7087 28.6222 8.21134 6.27257 3.16342 +6377 4 45.7172 37.2784 27.1471 -3.80026 -24.227 32.4306 +6378 6 54.0799 35.0377 20.3974 -0.144446 0.236923 -11.8112 +6379 4 53.8476 34.1116 20.536 0.519878 -4.41527 -2.37245 +6380 4 53.9532 35.2077 19.4441 0.866973 -0.817495 13.7238 +6381 6 42.0671 14.221 28.4749 -2.16655 -3.30611 3.54679 +6382 4 41.9442 13.9043 29.3971 9.00113 8.16851 -11.079 +6383 4 42.9986 14.4434 28.31 -2.56617 -4.72525 9.98454 +6384 6 34.845 7.68802 26.7053 1.50556 20.2543 7.34306 +6385 4 35.7046 7.39142 27.0344 -1.60005 -9.47728 3.59716 +6386 4 34.4934 7.05976 26.0702 4.4346 -10.8207 -3.70702 +6387 6 49.6605 30.7141 23.8514 -28.5275 -6.56067 -11.9374 +6388 4 50.4604 31.1934 23.8565 34.1351 17.5516 -0.640456 +6389 4 49.8146 29.9659 24.4072 5.37992 -19.8924 15.651 +6390 6 50.8948 7.80148 14.1671 21.5777 -12.9452 34.2787 +6391 4 50.8247 6.96775 13.7105 -4.99079 -12.0182 -18.7136 +6392 4 50.5655 8.51894 13.6572 -15.7049 17.9748 -24.3233 +6393 6 4.26893 39.4826 27.8512 8.9926 -8.51629 -1.47833 +6394 4 3.65831 40.2241 27.8513 -3.04259 7.34368 5.94949 +6395 4 4.00328 38.958 27.1013 -12.9816 -10.5728 -11.1653 +6396 6 8.75177 32.8341 8.22283 -21.5639 -30.1985 -34.1316 +6397 4 8.2383 32.1284 7.72694 10.6374 17.547 21.6449 +6398 4 8.83279 33.5372 7.56693 3.76401 9.53239 7.06969 +6399 6 52.9594 25.4882 9.38297 -25.0802 50.1357 20.0056 +6400 4 51.9882 25.4292 9.65119 35.7509 1.27265 -17.7678 +6401 4 53.158 26.4759 9.49827 -6.53976 -44.9947 -5.62964 +6402 6 29.5661 36.7256 19.4603 5.44621 -17.3757 32.4066 +6403 4 29.5786 37.3961 18.7906 9.88328 7.74732 -15.4263 +6404 4 30.4565 36.6309 19.8726 -14.3545 4.38723 -10.5986 +6405 6 52.3236 36.1013 25.1169 17.8415 -25.8683 -35.0149 +6406 4 52.9656 35.7372 25.71 20.0999 5.67458 7.00157 +6407 4 51.6595 36.4261 25.6714 -35.904 19.3861 23.0835 +6408 6 21.182 15.7103 31.1872 -18.8583 3.19523 -20.0756 +6409 4 20.6533 16.2005 30.5215 19.2403 -4.60119 13.454 +6410 4 20.518 15.2243 31.6931 2.46505 1.20146 2.10658 +6411 6 10.6569 22.4337 39.4531 2.51655 -26.4213 -37.4968 +6412 4 10.8327 22.4219 38.4645 -4.29248 9.16844 28.2769 +6413 4 10.2506 21.5589 39.6181 7.08653 12.2011 0.686531 +6414 6 25.1113 11.6729 22.7164 -12.9971 -0.576423 -18.0399 +6415 4 25.1382 11.4787 23.6279 21.2779 0.00518046 39.517 +6416 4 24.1824 11.5118 22.5586 2.84555 -0.272219 -17.8246 +6417 6 31.7896 10.4703 2.90217 -23.2712 -10.1944 -9.79051 +6418 4 32.6146 10.7499 3.28348 13.8778 6.97942 -8.99307 +6419 4 31.8394 10.4464 1.92418 10.0551 5.29594 18.2662 +6420 6 52.4849 36.4361 22.1663 -9.62786 -33.6069 5.21212 +6421 4 53.146 36.0606 21.5474 -12.5852 0.946736 4.3316 +6422 4 52.0694 35.6392 22.6209 17.7505 30.3514 -16.202 +6423 6 46.2093 40.0329 26.9877 0.0297183 29.9961 33.6049 +6424 4 46.4751 39.2742 26.5126 9.55695 -26.8643 -22.4205 +6425 4 45.9048 40.7092 26.3771 -3.76152 -2.91476 -3.34389 +6426 6 24.0885 36.7218 39.1011 7.12362 -3.16907 -4.80429 +6427 4 23.5999 35.9078 38.9667 11.8985 -11.6148 -5.9332 +6428 4 23.4559 37.2234 39.5891 -11.7402 16.6095 17.3029 +6429 6 22.3514 7.42547 31.8169 -35.2707 -41.8068 15.3628 +6430 4 22.2213 8.33277 32.0647 5.94025 21.3422 4.40196 +6431 4 21.6465 6.92073 32.3398 32.1745 21.6054 -24.7594 +6432 6 14.3502 18.3597 4.09728 -2.0055 -9.38358 23.348 +6433 4 14.1099 17.4219 3.93107 -0.92654 19.6042 10.3569 +6434 4 14.0726 18.5364 5.03654 13.0175 -10.3464 -23.9346 +6435 6 27.3175 38.46 0.124188 33.1007 -9.911 1.68747 +6436 4 26.9395 39.2806 0.463932 -4.88512 2.40457 5.81864 +6437 4 28.2608 38.413 0.45438 -35.2324 2.96259 -2.16122 +6438 6 18.6695 0.162292 12.2239 -43.166 1.81748 26.3235 +6439 4 17.7303 0.262878 12.5713 26.4571 2.30278 -22.2908 +6440 4 18.9433 41.3202 12.7499 8.63834 -11.46 6.42912 +6441 6 49.423 24.9792 25.3382 20.605 1.42964 -0.346179 +6442 4 48.5484 24.7002 25.6009 -12.613 -0.556076 -3.92373 +6443 4 49.3508 25.8032 24.8352 -9.8769 -5.62219 -3.2466 +6444 6 52.0685 20.2858 15.7446 -45.9435 -8.75518 14.7384 +6445 4 52.9731 20.5149 15.783 39.268 6.79994 2.42829 +6446 4 51.7449 20.2597 16.6676 4.81444 3.79951 -9.92674 +6447 6 49.6576 15.6472 38.4942 19.425 -17.6129 -0.00729052 +6448 4 49.2099 16.0165 37.7231 -6.98596 1.36616 -1.50856 +6449 4 49.5102 16.1958 39.2633 -14.7214 13.7889 5.58845 +6450 6 15.9211 23.7235 13.4193 23.3289 -36.8815 11.3263 +6451 4 16.506 23.7025 14.2147 -19.633 8.70021 -19.3267 +6452 4 15.5217 24.5725 13.2813 -7.62789 19.6624 11.7876 +6453 6 14.3566 29.1635 14.3074 -12.0826 22.9902 -11.8551 +6454 4 14.1263 29.6193 13.4563 6.10678 -19.1115 21.2229 +6455 4 14.1254 29.8374 14.9735 4.9154 -5.66101 -4.10969 +6456 6 30.4264 19.8612 16.8883 21.8822 -42.1222 -1.02119 +6457 4 30.7186 19.5182 17.7453 7.89699 4.38367 -1.56912 +6458 4 29.8579 20.5689 17.0557 -25.7709 36.069 4.20145 +6459 6 21.3137 21.0352 23.1207 17.1515 -0.95565 24.203 +6460 4 22.2175 21.149 23.495 -16.5785 2.35003 -9.75668 +6461 4 20.7278 21.0809 23.8918 1.9436 3.71589 -4.02445 +6462 6 32.3543 0.425745 25.2542 2.91189 -3.53517 -15.1456 +6463 4 32.2281 0.339162 24.2978 10.7775 -1.18886 4.59452 +6464 4 31.5305 0.792307 25.5362 -21.0885 6.89421 14.2132 +6465 6 26.144 32.4145 27.5224 1.5207 15.2147 0.716215 +6466 4 25.5792 33.1636 27.3089 1.00017 8.92672 2.49827 +6467 4 25.8737 31.7446 26.908 1.40169 -15.6227 -12.5261 +6468 6 31.6924 23.0038 41.4488 2.9891 4.25247 18.5975 +6469 4 32.5817 22.7219 41.7427 -10.6129 2.19465 -7.80737 +6470 4 31.0787 22.7203 0.234806 2.54762 2.31931 -6.22567 +6471 6 54.3675 17.8383 10.7129 6.79577 23.0573 52.4548 +6472 4 53.55 18.2477 10.4428 -14.1319 6.62767 -11.4304 +6473 4 54.6119 17.1874 10.0964 4.54612 -26.2874 -33.1105 +6474 6 15.4111 28.5567 8.624 -23.5209 17.7221 -14.2225 +6475 4 14.7074 29.0083 8.07604 23.4242 -18.2482 9.63627 +6476 4 15.9053 27.9212 8.07642 -10.4486 8.35345 -4.07335 +6477 6 21.923 22.3267 27.6697 4.39763 -15.072 3.90508 +6478 4 22.0757 23.261 27.7591 9.36727 14.8743 -6.39222 +6479 4 22.0153 22.013 28.5729 -4.02641 -8.91923 4.38679 +6480 6 2.936 17.0367 8.13301 26.8737 -0.816539 -9.93732 +6481 4 3.80704 17.1417 7.69888 -17.5309 -13.2134 -6.39661 +6482 4 2.90872 17.8246 8.6543 -8.08771 15.2208 15.3377 +6483 6 27.578 18.2783 3.98106 42.3665 -21.0645 -7.59535 +6484 4 26.9838 18.9866 3.87461 -35.9411 25.5305 -3.32845 +6485 4 28.3853 18.6252 3.56495 -11.0807 -10.9366 8.58166 +6486 6 24.7671 24.5333 8.4671 -3.55267 7.94183 -11.8318 +6487 4 25.0347 23.6359 8.24775 3.17664 -3.45343 1.13667 +6488 4 24.5725 24.5372 9.40731 3.34714 4.39373 0.466573 +6489 6 41.9868 30.4684 13.7801 28.6364 -21.7839 2.09937 +6490 4 42.9472 30.4515 13.6527 -5.43777 20.4489 -0.76134 +6491 4 41.8419 29.5153 13.705 -23.7897 6.87836 6.63004 +6492 6 15.6883 34.6775 41.5701 28.3539 0.757195 5.77675 +6493 4 16.4499 35.2822 41.5481 -1.40988 -1.74654 9.10263 +6494 4 14.9914 35.2483 41.869 -21.9895 7.57474 1.73196 +6495 6 11.1473 19.7636 40.5906 -7.01786 -3.24743 -12.0486 +6496 4 12.0915 19.8265 40.3679 -7.75233 -10.0339 3.8807 +6497 4 10.7912 18.9088 40.243 10.6872 10.1147 9.9033 +6498 6 47.4955 34.5311 14.2936 14.7321 -31.661 -1.66099 +6499 4 46.9342 35.3117 14.2317 -6.87541 2.2103 -19.2779 +6500 4 47.4978 33.9137 13.4978 -3.14061 27.4792 16.9676 +6501 6 12.3981 26.9866 28.4861 26.5251 -74.1409 -7.08463 +6502 4 13.226 26.8461 29.0045 -10.1246 11.0422 -0.548558 +6503 4 12.3843 26.0988 27.9797 -6.45597 45.1087 15.272 +6504 6 27.6352 16.207 39.8297 -11.2321 14.8168 6.13397 +6505 4 27.2166 15.4175 40.1567 -13.0977 -6.13948 14.8525 +6506 4 28.2209 15.8539 39.184 23.7477 -3.37658 -20.6816 +6507 6 33.4012 31.2187 27.2758 -9.34358 5.5086 -22.6345 +6508 4 34.125 31.7676 27.5967 0.31405 7.14405 -9.79506 +6509 4 32.8978 31.7031 26.5666 21.3968 -7.09575 17.214 +6510 6 39.0983 39.5786 31.9234 0.802497 -2.15341 -0.194752 +6511 4 38.8245 39.6381 30.9898 -0.836727 0.773065 10.2743 +6512 4 38.5517 40.2102 32.4207 8.13236 -5.11153 -2.10971 +6513 6 22.8875 16.5662 19.9556 -18.6429 -47.4181 0.677292 +6514 4 23.2714 15.7467 20.3471 4.73069 19.3315 1.98369 +6515 4 22.0725 16.1814 19.5628 10.6014 14.9969 -2.71875 +6516 6 23.9725 21.8734 10.5896 -27.2099 14.1239 -19.8382 +6517 4 22.9807 21.8764 10.5048 23.1264 -0.860286 11.7265 +6518 4 24.1883 21.166 11.1844 -1.51334 -13.3572 20.4185 +6519 6 40.1791 25.4384 2.79385 3.27033 10.4385 -27.7191 +6520 4 40.1215 24.9503 3.60378 -1.57927 -2.0951 21.761 +6521 4 39.8421 26.3422 2.89187 -4.34677 -6.39915 11.9951 +6522 6 15.0222 19.7637 9.4145 -47.1416 28.5942 15.5409 +6523 4 14.7277 20.7258 9.2944 13.9352 -33.0223 -5.4956 +6524 4 14.1981 19.3167 9.80349 37.3596 11.4933 -12.2096 +6525 6 7.16734 24.8761 0.122492 -38.9593 -14.3052 4.78001 +6526 4 7.92262 24.7355 41.4818 28.9246 2.82935 -8.29154 +6527 4 7.37325 25.3267 0.937782 12.1222 2.94845 5.10402 +6528 6 43.395 10.8961 31.3295 35.6095 27.14 14.9602 +6529 4 43.8689 11.0333 30.4778 -14.9331 -12.4968 13.4948 +6530 4 44.125 11.0026 32.0067 -24.5429 -5.74221 -22.764 +6531 6 13.8447 19.0699 27.8622 -3.35019 15.2359 -6.83255 +6532 4 12.9833 18.7163 28.0985 -4.55464 1.4506 5.93475 +6533 4 13.7874 20.0538 27.8435 3.60016 -14.5834 0.921784 +6534 6 3.48728 19.5892 9.61273 -55.7314 7.48447 -10.4955 +6535 4 2.69835 20.0905 9.96963 22.9021 -19.0673 -4.76373 +6536 4 4.2501 19.9102 10.0538 23.4289 5.03115 15.3445 +6537 6 51.0169 19.4212 7.7195 26.3048 39.1054 -53.7154 +6538 4 50.748 20.2575 7.21364 -2.7273 -32.3506 28.7892 +6539 4 51.8579 19.2204 7.21263 -29.2082 -7.0208 18.9647 +6540 6 42.2149 2.6091 10.4112 25.8935 -20.0624 -18.8025 +6541 4 43.1623 2.45904 10.6444 -24.152 11.2038 4.82319 +6542 4 42.1853 2.33112 9.4647 -3.80011 10.6068 21.7004 +6543 6 30.7928 6.43901 35.1986 -21.6247 -20.8821 1.11778 +6544 4 29.8295 6.39304 35.3716 10.0359 5.79706 -2.44011 +6545 4 31.0478 5.50645 35.0814 0.649811 9.90023 -1.69835 +6546 6 52.8722 36.96 18.5947 9.01539 9.27494 -7.55423 +6547 4 52.0657 36.4448 18.5061 -12.9065 3.13675 2.3407 +6548 4 52.6935 37.8522 18.2226 2.03776 -15.609 7.12003 +6549 6 44.2018 6.29599 1.04883 9.29405 17.1768 7.51252 +6550 4 44.5044 7.06671 1.58929 -4.49779 -17.4812 -0.431191 +6551 4 44.952 6.10526 0.487985 -0.115844 -2.61588 -3.46335 +6552 6 42.1326 38.6047 31.1849 18.5327 -13.3283 33.8135 +6553 4 41.7834 38.9864 30.4106 -14.9936 10.8543 -35.8121 +6554 4 41.4904 38.8324 31.8627 -0.641051 1.33351 1.93 +6555 6 43.7219 12.8013 9.05519 -6.282 7.91343 -40.7352 +6556 4 43.3171 13.69 8.87718 10.3632 -22.6116 8.3507 +6557 4 43.9578 12.415 8.15014 1.61383 14.3586 37.3488 +6558 6 13.4062 0.438838 6.51561 -30.6084 29.4042 -0.600484 +6559 4 12.9719 1.14899 7.05573 20.0807 -17.3818 -8.1595 +6560 4 13.3782 0.782754 5.59696 2.59294 -3.03922 8.63079 +6561 6 16.1217 13.2907 10.2805 -3.10591 -25.3511 -12.454 +6562 4 16.8946 12.7568 10.5076 8.02861 4.25978 2.86397 +6563 4 15.5299 12.6092 9.88546 -0.135156 17.9383 7.81515 +6564 6 1.59113 8.48217 4.69745 0.410151 -22.2633 16.3582 +6565 4 1.97054 9.1194 4.11301 8.92831 16.113 -22.7699 +6566 4 2.26765 8.43533 5.38895 -6.97239 3.0759 6.50405 +6567 6 37.2935 1.72102 10.5172 -13.7439 -9.21578 15.0824 +6568 4 37.1042 2.64553 10.595 10.0955 20.4226 -13.0857 +6569 4 36.8105 1.41855 11.2983 8.13599 -13.5394 -0.658926 +6570 6 53.8411 9.88961 17.6933 -45.7386 -38.9159 3.57486 +6571 4 54.5353 10.0399 17.0846 27.4782 6.59889 -23.5339 +6572 4 53.3721 9.08338 17.329 10.482 22.3983 14.0606 +6573 6 45.4787 30.6173 15.8038 -24.3966 -4.27047 13.1326 +6574 4 44.7717 31.1876 16.1963 22.3351 -9.42651 -10.1125 +6575 4 45.1907 29.6979 15.9324 6.84487 10.052 -2.21901 +6576 6 39.9241 16.6394 33.8426 -26.8877 -6.37158 -14.218 +6577 4 39.1549 17.2016 33.5476 23.291 -18.1751 3.42158 +6578 4 39.818 15.753 33.3934 2.94846 26.4583 15.0268 +6579 6 32.8532 24.7638 27.9368 9.55773 21.8346 -14.3088 +6580 4 33.6229 25.0593 28.4772 -14.6217 4.84572 -15.4057 +6581 4 32.6055 25.4822 27.2751 14.9958 -18.2832 35.5187 +6582 6 7.86628 31.6164 24.1091 22.2934 14.9204 62.1634 +6583 4 7.77595 30.8628 24.7489 -5.82572 16.0022 -25.8365 +6584 4 8.17309 32.3545 24.746 -24.9312 -26.1857 -42.8493 +6585 6 43.5324 41.3356 15.8165 16.5067 -5.02973 0.188395 +6586 4 43.1944 0.320073 15.7896 -5.69638 5.43212 -4.38793 +6587 4 44.429 41.3992 15.443 -10.6291 -2.88383 0.315207 +6588 6 20.021 29.5505 33.1902 25.0419 -7.98688 14.3875 +6589 4 20.8911 29.4069 33.5992 2.6372 -12.3274 -8.42754 +6590 4 19.6576 30.1636 33.8147 -14.9588 14.7065 -0.197692 +6591 6 43.4056 21.4569 18.6265 10.2156 -2.1017 15.5441 +6592 4 43.0498 21.3696 19.5313 -0.699705 -7.60676 -10.3888 +6593 4 42.9844 20.831 18.0298 -12.2248 -1.50447 0.773582 +6594 6 3.43117 19.1215 18.408 34.3393 4.70286 11.768 +6595 4 3.22621 20.0564 18.4267 -2.18643 4.81974 -5.59269 +6596 4 2.60088 18.6799 18.3703 -20.3233 -14.3491 -1.28903 +6597 6 41.6742 38.1112 16.3299 0.384784 -42.0766 -46.2559 +6598 4 41.8939 37.3404 15.6708 -9.75075 44.1094 34.3099 +6599 4 42.3403 38.1083 17.0131 5.25517 -2.87066 6.28124 +6600 6 7.56339 36.3915 10.5048 -18.8567 -13.4705 -13.5944 +6601 4 6.70677 36.1596 10.0967 9.18231 15.0261 0.193132 +6602 4 7.92251 35.493 10.5558 6.04756 10.3771 12.1048 +6603 6 36.2642 19.1103 34.8187 -40.4108 -29.7457 -43.4097 +6604 4 35.4719 19.3187 34.2477 20.3247 -4.92751 27.2967 +6605 4 36.4213 19.8813 35.3193 7.80254 33.8099 20.7293 +6606 6 53.576 24.9483 12.6399 1.20561 -0.517111 -17.326 +6607 4 53.6619 25.9414 12.669 8.79141 -29.2645 -7.24265 +6608 4 53.913 24.5623 11.7782 -4.09912 18.2899 28.1509 +6609 6 31.6824 10.4618 21.0892 -21.9557 -25.3726 -8.81809 +6610 4 31.4281 9.67391 21.5915 5.84781 10.5911 6.7189 +6611 4 30.8909 10.5838 20.5303 11.506 8.60894 0.332243 +6612 6 18.1093 28.7861 17.1823 13.2379 18.2354 -13.1758 +6613 4 19.074 28.7105 16.9739 -24.5165 5.38082 5.29014 +6614 4 17.7652 29.607 16.728 11.5472 -26.6353 13.0333 +6615 6 21.6834 18.2239 36.88 17.2587 0.811675 -5.67627 +6616 4 22.5671 18.027 36.4721 -27.7349 -1.55215 19.1593 +6617 4 21.6367 17.7543 37.7464 -1.70499 5.95625 -12.509 +6618 6 25.0551 19.0348 34.2287 -62.1041 -5.07763 23.2016 +6619 4 24.7663 18.3443 34.8719 5.43786 16.9757 -10.9409 +6620 4 25.8827 18.7578 33.9618 64.2031 -27.8273 -22.1538 +6621 6 15.5709 13.019 5.5539 0.00735057 -17.6807 20.5563 +6622 4 15.9927 13.3293 6.36292 0.0692085 12.4919 -5.39058 +6623 4 15.4491 12.0681 5.73828 -2.05735 13.2604 -17.7033 +6624 6 54.47 41.6402 14.7959 12.609 -13.6787 23.2741 +6625 4 54.8097 41.4531 15.6947 -1.45983 11.4249 -10.5768 +6626 4 53.7709 40.9948 14.7271 -15.6812 0.146288 -8.92901 +6627 6 1.6639 26.4809 31.3827 12.672 -25.15 69.1319 +6628 4 2.55491 26.3764 31.7735 -12.447 -0.333387 -5.00094 +6629 4 1.81595 26.6127 30.4938 10.6163 16.8649 -70.5286 +6630 6 32.3417 37.2868 29.6843 -28.8191 13.9029 5.49332 +6631 4 31.5776 37.8992 29.8843 22.0104 -18.6347 -4.04342 +6632 4 33.1171 37.6855 30.0945 4.79121 1.59444 1.77014 +6633 6 52.7104 21.0422 22.8867 -25.9211 15.4876 17.6965 +6634 4 51.8895 21.5407 22.5959 27.9099 -16.7396 2.24416 +6635 4 53.1785 20.6742 22.1421 1.33026 -7.16251 -14.9349 +6636 6 32.7465 28.5808 40.5193 19.5614 -2.95666 4.13778 +6637 4 32.1272 29.2507 40.2236 -19.1805 -2.02865 5.11045 +6638 4 32.5793 28.3106 41.4408 -7.78706 5.87783 -13.0149 +6639 6 23.6078 32.0654 16.3528 6.52471 10.7856 29.7964 +6640 4 24.3701 32.0729 16.9793 -11.8963 -10.2614 -20.8491 +6641 4 22.8856 32.382 16.9256 -1.99185 -7.37994 -15.8659 +6642 6 37.5296 9.17182 29.9714 -32.9897 5.30306 10.5453 +6643 4 36.7716 8.86544 30.5111 15.5785 -5.70066 -5.7121 +6644 4 37.1221 9.9689 29.5744 15.1662 -5.45151 -1.53858 +6645 6 2.26386 24.3835 14.5546 6.71022 -7.72281 -24.2479 +6646 4 1.85963 24.0133 15.3587 -6.19133 3.33276 -9.20692 +6647 4 2.05254 23.8227 13.7642 -0.610841 12.6744 29.5344 +6648 6 27.3686 28.7935 24.7702 8.50672 -13.2399 -34.495 +6649 4 27.2338 28.4442 25.6457 -6.20833 -8.14759 12.6395 +6650 4 27.3624 28.0447 24.1031 3.25167 21.2409 25.246 +6651 6 16.785 2.54959 14.3094 -6.20571 44.0359 18.8502 +6652 4 17.7332 2.53792 14.3228 12.8455 -14.2273 -3.64568 +6653 4 16.4133 1.8101 13.8617 -1.35631 -25.1723 -17.3636 +6654 6 21.8048 39.8028 36.8143 34.4281 41.1875 6.43987 +6655 4 22.7768 39.6281 36.9504 -24.2083 -5.20947 -5.56999 +6656 4 21.4132 39.0119 36.5213 -11.0202 -42.2818 -12.3994 +6657 6 14.0639 6.48367 41.5586 -1.33856 -25.5903 -39.7582 +6658 4 14.9412 6.10051 41.3922 2.86672 3.38346 15.7648 +6659 4 14.0719 7.05039 0.399753 4.3465 12.2327 22.8772 +6660 6 14.5548 16.5075 9.32956 22.0841 -14.7784 -21.2506 +6661 4 15.3586 16.5914 9.87503 -6.36199 2.72911 -6.08794 +6662 4 13.8899 17.0883 9.65711 -8.71884 14.1475 23.1102 +6663 6 8.67066 23.4815 30.5556 -44.0195 -7.59097 13.7496 +6664 4 9.49671 23.6557 30.1334 33.8338 1.75787 0.0184994 +6665 4 8.69311 23.4014 31.5307 16.0679 1.7618 -7.5699 +6666 6 37.6567 2.07706 19.9993 -10.7882 4.4912 14.9507 +6667 4 36.977 2.26584 19.3592 -1.31755 -8.36894 -24.369 +6668 4 37.311 2.65872 20.6865 17.7477 -2.01295 10.0374 +6669 6 42.7201 7.55732 8.02256 37.7013 -31.8103 68.6738 +6670 4 43.2078 7.90139 7.31041 13.9641 18.3531 -33.1003 +6671 4 43.4713 7.36984 8.74143 -54.3005 13.1784 -34.8973 +6672 6 38.5678 29.6657 6.85728 10.4727 -7.97498 12.0381 +6673 4 38.5138 29.2192 7.70857 5.95943 6.40388 2.63109 +6674 4 37.7242 29.471 6.47402 -15.8477 4.38345 -15.5494 +6675 6 42.5297 15.7017 39.7864 -1.2311 2.72873 2.24862 +6676 4 42.7877 16.6334 39.6476 -7.55712 -4.9727 -7.52807 +6677 4 42.0746 15.3358 38.9963 17.4435 12.5166 7.69263 +6678 6 19.8571 7.43592 22.0545 -24.1472 -5.51637 33.4113 +6679 4 19.2244 8.12179 21.7601 9.35088 -5.78158 -2.10146 +6680 4 19.4596 7.11536 22.9248 14.2781 17.6372 -34.9907 +6681 6 27.4149 3.22069 12.5516 40.9266 14.4549 -35.8463 +6682 4 28.3021 3.29229 12.0821 -30.0356 5.19144 18.8294 +6683 4 27.3767 2.28812 12.7581 -5.67627 -4.82192 6.74426 +6684 6 34.4116 6.50186 34.3661 -21.9879 -4.07114 7.78674 +6685 4 33.6675 7.13398 34.4265 8.52018 -4.33452 -1.60522 +6686 4 34.0848 5.70903 34.842 8.55338 12.1797 -0.556276 +6687 6 9.89342 27.9558 39.7643 36.6491 -8.46867 13.0669 +6688 4 10.8456 28.0225 40.104 -41.9626 -4.51635 -15.7261 +6689 4 9.67004 28.8098 39.3873 2.34979 10.3628 -2.65954 +6690 6 50.5619 22.115 6.39208 17.1303 26.4748 31.0688 +6691 4 51.4904 22.4109 6.45725 -8.74694 -11.3909 -7.00891 +6692 4 50.1939 22.6078 7.15954 -8.62199 -11.7106 -16.757 +6693 6 47.1151 11.4881 30.0373 19.0993 -20.4412 31.5796 +6694 4 47.2481 10.8506 30.7795 8.25865 21.4973 -13.9376 +6695 4 46.3269 11.1564 29.6474 -26.9131 -5.13028 -17.9745 +6696 6 25.9416 28.4741 9.79918 -11.6773 -32.55 32.2578 +6697 4 26.8348 28.2861 10.1548 -13.4597 2.20587 -7.83095 +6698 4 25.3328 27.8368 10.2912 20.3964 27.2145 -12.4741 +6699 6 35.4384 36.5941 19.4416 12.9267 19.1414 22.694 +6700 4 35.4164 36.6623 20.432 -0.885856 -8.21646 -20.3497 +6701 4 36.1159 37.2681 19.2232 -9.51806 -6.29836 -4.59986 +6702 6 39.0948 17.8654 12.2958 16.402 12.2899 -6.89152 +6703 4 39.0474 18.8007 12.5965 -2.38328 -10.6878 -1.40665 +6704 4 38.4419 17.3626 12.7715 -16.1853 0.319976 14.0097 +6705 6 2.67108 27.1436 2.40101 -1.75759 -3.65761 -8.1759 +6706 4 1.9876 27.5644 1.84788 8.2175 -2.76418 4.2561 +6707 4 2.53155 27.392 3.3289 1.87867 -1.67129 -3.85288 +6708 6 12.3359 32.2055 21.5153 -21.7508 0.12991 31.168 +6709 4 12.6488 32.0797 22.4173 29.0853 13.2861 -13.6486 +6710 4 11.491 31.8094 21.7155 -17.148 -0.720271 -25.2422 +6711 6 32.8833 32.3716 8.45599 -19.6455 -21.472 -14.5807 +6712 4 33.4538 32.8256 9.05859 9.48117 21.6574 11.6239 +6713 4 31.9723 32.7028 8.50155 9.17651 3.82723 3.41156 +6714 6 12.6485 6.44458 31.9777 -6.29944 1.49663 15.4125 +6715 4 13.1578 6.35833 31.1835 12.9638 -3.65534 -14.9347 +6716 4 11.7474 6.25334 31.7296 -4.07419 -1.29291 -2.47195 +6717 6 41.3645 27.7433 14.0415 -6.01814 -18.8263 -25.007 +6718 4 41.8124 27.3175 13.2596 -11.5333 15.588 22.1217 +6719 4 40.3975 27.5756 13.9407 20.5065 3.01622 5.4742 +6720 6 6.60161 16.499 25.4489 9.93734 -1.87947 -15.8553 +6721 4 7.35848 15.8951 25.4583 3.3895 5.33583 -1.00098 +6722 4 6.02379 16.0419 24.8253 -6.53341 1.34025 8.2366 +6723 6 21.7786 39.2974 13.3607 -58.7317 27.2846 42.4257 +6724 4 22.3848 39.3902 12.6828 41.4687 -6.70168 -50.5194 +6725 4 21.6228 40.2371 13.624 5.27297 -27.3266 2.34771 +6726 6 34.8408 6.01319 6.94562 -18.4641 -1.51643 5.78804 +6727 4 33.8445 5.90926 6.91888 31.3517 2.57767 -4.40922 +6728 4 35.1545 6.28252 6.0657 -8.54142 -2.93715 0.97402 +6729 6 33.0232 30.4151 33.1713 -30.7469 -3.39927 -39.9685 +6730 4 32.1382 30.6983 32.7963 25.7009 -18.3352 9.36685 +6731 4 33.1108 30.988 33.8978 7.7837 23.494 30.6115 +6732 6 15.4491 32.4129 12.2013 37.3068 -21.1945 16.3611 +6733 4 16.3823 32.073 12.2446 -28.3662 8.39135 1.47263 +6734 4 15.4224 32.8258 11.3561 0.313824 15.5191 -23.5701 +6735 6 12.6648 26.6033 21.3782 33.3074 -46.6123 -64.9668 +6736 4 12.0344 25.8976 21.5501 -12.6652 14.4466 17.403 +6737 4 12.7392 27.3327 21.935 -15.9008 39.2731 46.5109 +6738 6 47.0171 36.3051 29.9756 -14.9097 -3.99946 59.7783 +6739 4 47.3887 37.0247 30.5306 -0.120183 -5.44251 -19.0377 +6740 4 46.4147 35.8463 30.6463 22.302 11.6315 -30.1098 +6741 6 0.299553 12.7005 23.3858 -50.0817 10.3486 20.6993 +6742 4 0.55843 11.8154 23.133 6.9712 -0.709946 -9.28769 +6743 4 54.2783 12.6185 23.429 39.7411 7.62342 -2.706 +6744 6 54.1651 18.9185 21.5773 -27.3575 7.2555 -32.8787 +6745 4 0.055729 18.801 21.8215 42.2187 -10.4087 33.76 +6746 4 54.2632 18.7361 20.6344 -21.3012 2.13243 0.141772 +6747 6 25.7162 24.2884 23.7449 23.2111 -33.139 -2.25213 +6748 4 25.1836 23.5617 23.2944 18.61 24.747 21.927 +6749 4 26.5708 23.8587 24.0884 -36.4232 14.4676 -16.0896 +6750 6 11.8952 29.0236 26.8796 9.31073 -5.31833 9.58593 +6751 4 12.582 29.6684 27.1204 -3.01706 -1.21814 -5.31042 +6752 4 12.0145 28.319 27.5465 -5.16863 11.8863 -12.5997 +6753 6 48.0052 35.8598 10.6996 -18.0426 -22.591 -32.4945 +6754 4 48.7896 35.6794 10.1443 -7.64403 10.0758 9.7343 +6755 4 48.2747 36.3464 11.4544 19.4818 11.8303 20.3364 +6756 6 47.6544 29.8545 36.9555 47.7155 -39.8456 -42.9298 +6757 4 48.1196 29.373 36.1789 -16.9409 17.9192 43.9777 +6758 4 46.9556 30.2951 36.4995 -17.6283 12.0501 3.0439 +6759 6 7.32865 12.3513 10.6225 -20.3459 13.1064 -14.334 +6760 4 7.20572 12.8267 9.76478 7.03806 -14.4953 16.449 +6761 4 6.49136 12.5857 11.0944 24.1086 -12.0498 -8.15528 +6762 6 52.9256 15.9641 4.89737 -18.3283 -2.7411 -11.4996 +6763 4 53.001 16.1105 3.94443 2.36662 -0.713792 8.85774 +6764 4 53.8018 16.0105 5.25645 21.1817 2.44507 8.14275 +6765 6 10.6731 16.9472 34.6118 -36.7423 -4.99845 -47.4494 +6766 4 11.0533 16.8484 35.4724 -5.12202 -12.2675 26.0308 +6767 4 9.83371 16.4151 34.3796 40.245 18.7583 25.5995 +6768 6 25.147 31.0596 36.0152 -5.60145 -19.7687 -32.0201 +6769 4 25.7935 31.7656 36.1171 1.22463 2.78419 -3.72446 +6770 4 25.3418 30.5949 35.1615 -4.38154 15.6016 24.1358 +6771 6 34.0913 21.8858 41.4775 -4.76405 18.1665 32.5634 +6772 4 33.6625 21.1007 41.1787 -2.29922 -28.5955 -6.85504 +6773 4 34.6054 22.1733 40.7506 14.2114 10.2598 -30.2937 +6774 6 15.7731 30.0818 1.26798 39.0641 -13.3599 -49.0464 +6775 4 15.0823 30.4241 1.791 -23.818 19.5269 30.6537 +6776 4 16.2108 30.862 0.84325 -15.3415 -19.24 18.755 +6777 6 29.5302 27.8609 16.6022 -41.3972 -29.0796 28.0786 +6778 4 29.3307 26.8764 16.753 17.6765 42.2449 -1.67193 +6779 4 28.8227 28.3009 17.156 20.6394 -5.21731 -15.3441 +6780 6 39.6438 9.77612 0.552706 9.07327 13.2864 29.0584 +6781 4 40.129 10.5839 0.897097 -15.1313 -20.9808 -12.8857 +6782 4 39.4906 9.23066 1.36029 2.34479 9.54176 -15.0004 +6783 6 1.51524 31.8825 16.4089 -15.0842 0.567558 32.708 +6784 4 2.11225 32.2249 15.7721 17.5465 17.6302 -23.3114 +6785 4 1.56386 30.9485 16.2687 -0.663138 -25.5376 -6.36093 +6786 6 8.73078 39.8635 25.0545 2.96185 -34.7465 -17.9129 +6787 4 8.00321 39.5602 25.6169 4.07363 9.59654 5.53067 +6788 4 8.89391 40.7829 25.2096 -1.06312 24.7623 5.36493 +6789 6 42.3301 10.2778 9.76455 0.0249942 22.0437 -8.66619 +6790 4 42.035 10.1947 10.6715 6.68889 -4.55788 7.04955 +6791 4 42.6957 11.1854 9.68656 -1.85544 -15.7885 0.75259 +6792 6 13.241 7.61416 1.95847 -11.6175 -6.73398 30.6404 +6793 4 13.9892 7.82191 2.54806 -1.36929 5.6022 -7.80568 +6794 4 12.5695 7.22502 2.56499 11.7798 7.16895 -16.7116 +6795 6 18.7434 40.0583 14.2212 10.8937 -7.32712 21.4541 +6796 4 19.2417 39.7541 15.0131 -1.99408 15.6159 -18.1773 +6797 4 17.935 39.549 14.2832 -4.44855 -3.57314 -3.37042 +6798 6 20.0977 14.0454 38.5561 35.4799 -67.417 -7.49733 +6799 4 20.2641 13.632 37.67 -9.31749 10.6865 24.2255 +6800 4 19.7827 14.877 38.3297 -23.7972 64.5272 -8.60678 +6801 6 22.6565 28.8842 34.0588 -5.52315 8.37947 20.7951 +6802 4 23.0585 28.228 33.4828 2.77778 -4.34029 0.307399 +6803 4 22.9395 28.703 34.9822 0.354749 -6.57221 -14.6515 +6804 6 22.6874 4.70198 5.2328 -25.042 -9.90055 15.5414 +6805 4 22.1274 3.9708 5.56882 12.1557 -0.0327816 -16.8284 +6806 4 22.5434 5.31639 5.94822 12.9551 16.3877 4.62095 +6807 6 23.6492 33.9942 38.3998 23.375 33.8394 -43.1733 +6808 4 22.8011 33.6715 38.57 -44.227 -25.7371 21.164 +6809 4 23.4749 34.4069 37.5183 19.103 -7.547 16.6445 +6810 6 48.374 21.3549 17.2744 -0.727013 41.2048 -23.9838 +6811 4 48.2041 22.3166 17.0448 3.0192 -25.1475 26.0409 +6812 4 48.3509 20.9743 16.3868 -2.31832 -8.94154 10.8829 +6813 6 11.5758 10.9938 8.63273 -18.0621 42.8191 15.9647 +6814 4 11.6313 10.2483 9.25156 -2.19238 1.01339 1.87179 +6815 4 11.0547 11.7764 9.03291 21.9333 -36.8133 -6.7089 +6816 6 40.0924 28.1686 33.4857 17.1635 -5.37387 30.2378 +6817 4 41.046 28.3881 33.5354 -13.2006 -3.32107 -11.2861 +6818 4 39.7443 28.4933 32.6629 4.51627 6.28126 -11.3213 +6819 6 47.3837 25.6703 5.29617 28.7657 21.9065 -4.48206 +6820 4 46.461 25.5322 5.12569 -20.8862 2.51482 -4.893 +6821 4 47.6179 26.6114 5.08959 -12.3293 -15.1007 -0.275896 +6822 6 21.6517 35.2222 23.996 27.7917 10.3485 -3.89698 +6823 4 21.6311 34.5383 24.6593 -10.5502 -12.8786 6.64496 +6824 4 22.5954 35.4881 23.9966 -15.7417 2.23004 -2.6139 +6825 6 8.24409 41.4919 8.41354 9.22969 12.4334 -12.8549 +6826 4 8.15 40.8674 7.67873 -1.07657 -2.81584 5.48771 +6827 4 7.83543 41.113 9.18983 -1.52095 -3.2343 5.88405 +6828 6 16.4798 31.1082 22.2131 -4.24513 -17.8742 -2.35359 +6829 4 17.0752 30.8161 21.5077 -7.18137 4.28218 -7.0656 +6830 4 17.0564 31.1902 22.9696 5.97679 -0.907857 10.4567 +6831 6 54.7122 0.459271 28.3177 -16.7834 -37.5181 -6.57119 +6832 4 0.641958 0.15455 28.3975 4.09167 16.1916 -1.73275 +6833 4 54.5379 1.34634 28.6236 20.797 14.6923 4.72985 +6834 6 48.4477 15.3762 4.17752 -7.35125 -30.0531 -4.44848 +6835 4 49.1738 15.1128 4.81019 -14.8803 0.337287 -24.8229 +6836 4 48.0902 14.5922 3.6288 23.2827 31.0113 24.8784 +6837 6 34.3541 7.00171 40.4295 26.6588 -46.9533 -23.8625 +6838 4 33.6168 6.99428 39.8319 -14.4938 10.2897 -3.98371 +6839 4 34.9839 6.35967 39.9588 -19.3291 28.4488 24.7248 +6840 6 41.3507 3.37676 17.0028 -19.6969 -26.4955 -6.96819 +6841 4 41.02 2.66518 17.5936 5.53648 12.9859 -1.78552 +6842 4 41.944 3.90566 17.5305 10.5068 9.85924 8.73726 +6843 6 48.4427 20.685 14.5419 46.8112 -36.6841 26.4704 +6844 4 48.0177 21.3487 14.0717 -32.7597 47.8552 -32.6818 +6845 4 49.3877 20.9188 14.5227 -9.08294 -4.43462 -1.64124 +6846 6 52.4922 28.1277 37.1182 6.87418 8.84651 -10.3419 +6847 4 53.4134 28.4024 37.0408 3.12987 -6.6922 4.15316 +6848 4 52.2752 27.8963 36.2007 -7.47166 7.06161 9.73328 +6849 6 53.8774 18.5638 18.79 -18.2161 -77.5341 7.0005 +6850 4 54.7018 18.1425 18.5274 3.76082 -0.315502 -3.76089 +6851 4 54.0435 19.4528 18.7445 16.4561 77.5259 -2.54699 +6852 6 41.0011 39.1407 28.7879 -31.3786 -4.09579 71.7092 +6853 4 41.3911 39.2094 27.9661 28.9736 8.71878 -68.6315 +6854 4 40.0521 39.3021 28.7019 -2.27612 -3.41331 -6.23213 +6855 6 38.2743 8.75074 24.2285 24.5029 -7.68366 -19.8132 +6856 4 39.1919 8.60362 23.8621 -28.3827 4.68959 18.7737 +6857 4 38.3545 9.42009 24.9092 0.456349 2.35846 11.2764 +6858 6 2.99111 29.1615 9.6319 43.2691 -54.6401 14.341 +6859 4 2.5338 28.6319 8.99687 -12.0219 1.86489 -18.3516 +6860 4 2.58318 29.9865 9.638 -27.8835 49.5023 8.75508 +6861 6 27.5756 29.2755 18.3378 -4.01048 -11.7045 41.1881 +6862 4 26.7643 29.1652 17.8389 -11.7278 -2.11582 -9.62984 +6863 4 27.2839 29.0037 19.2864 20.9622 13.2114 -52.0932 +6864 6 11.8501 21.1733 10.1172 4.58733 -51.566 26.4002 +6865 4 12.2099 22.0246 9.9906 13.4732 33.828 -10.0235 +6866 4 12.4495 20.7458 10.776 -15.5727 16.0367 -15.8372 +6867 6 16.9004 32.2989 0.299881 0.133752 -22.2186 -6.7835 +6868 4 17.7029 32.7095 0.626455 9.4749 11.3588 3.4417 +6869 4 16.2118 32.9605 0.285394 -3.66285 20.1796 -4.1714 +6870 6 1.30064 17.4766 22.5523 32.9941 -5.4384 -19.965 +6871 4 1.2446 16.5356 22.2294 -6.1018 21.6977 3.5382 +6872 4 2.22906 17.8023 22.3815 -23.7878 -13.737 8.2324 +6873 6 41.5474 6.85538 29.3077 15.2611 30.5857 3.861 +6874 4 41.7413 5.96016 29.5642 -1.91107 -14.5726 0.121693 +6875 4 42.0251 7.37916 29.9826 -12.8279 -1.76094 -5.06557 +6876 6 10.5087 10.782 13.8577 27.0965 -13.6956 13.3978 +6877 4 10.7007 11.2274 13.0253 -2.16043 3.73872 -7.98734 +6878 4 11.2742 10.169 14.0479 -24.5023 11.0776 -3.5626 +6879 6 39.8289 15.4978 40.8346 25.2099 1.13818 0.661387 +6880 4 40.0487 16.0673 40.0758 -9.90377 -2.84048 2.34508 +6881 4 40.6829 15.4254 41.3222 -18.4618 6.82556 -4.74882 +6882 6 26.5164 19.6052 40.5088 -9.33805 1.61856 -11.7217 +6883 4 27.41 19.9717 40.4897 0.274496 -7.70925 5.49567 +6884 4 26.4209 18.9712 41.2422 6.64723 7.57269 5.06511 +6885 6 54.036 8.18782 13.7715 27.5212 34.9045 -2.54262 +6886 4 54.5316 7.46918 14.1378 9.61628 -19.3806 0.327355 +6887 4 53.1925 7.88218 13.5309 -39.9219 -15.1658 -7.5943 +6888 6 15.6949 25.3434 10.6718 -31.7842 -7.37099 0.0612328 +6889 4 15.1805 25.3333 9.84403 14.6699 1.30202 -4.92807 +6890 4 14.9666 25.3615 11.3188 15.8696 -4.15214 -3.47235 +6891 6 18.5987 3.44175 21.9294 71.7321 -9.69418 15.9409 +6892 4 19.6071 3.44542 22.1959 -64.1569 1.8736 -14.3483 +6893 4 18.6296 3.58776 20.9721 -7.77871 5.49431 4.81248 +6894 6 50.8883 20.6265 18.5187 28.1172 41.6529 17.9746 +6895 4 50.1573 21.1733 18.1958 -9.23125 -9.06144 -4.34911 +6896 4 51.4834 21.2842 19.0045 -23.468 -29.5191 -15.1667 +6897 6 53.3673 20.9038 31.2869 -12.1652 -1.18869 -3.23134 +6898 4 53.2409 20.9073 32.2442 5.88471 -1.70994 -0.407299 +6899 4 52.4717 20.8062 30.9053 11.2743 1.61965 3.90294 +6900 6 52.8102 27.6189 28.9831 -34.4743 -7.30027 30.0453 +6901 4 52.2848 27.4362 29.7987 1.4862 0.901255 -27.4551 +6902 4 53.4947 28.1361 29.3473 35.4934 25.3811 1.80223 +6903 6 33.3112 15.6955 11.3264 12.7704 9.00306 37.7013 +6904 4 33.4999 16.1238 12.2198 -3.00415 -23.4283 -28.8796 +6905 4 32.4346 16.0003 11.1059 -7.33456 8.94646 -4.12361 +6906 6 20.3875 26.8057 27.4813 21.213 -4.31231 15.2493 +6907 4 19.6396 27.3594 27.2578 -2.8557 9.66202 -0.370116 +6908 4 20.9667 27.2946 28.1279 -24.4059 -13.8952 -19.2793 +6909 6 8.54399 2.06163 14.1713 4.36483 17.1543 -0.299448 +6910 4 8.13837 1.20516 14.196 -9.47708 -17.773 2.17407 +6911 4 8.01805 2.60085 14.7902 6.78451 -6.83093 -3.12033 +6912 6 40.1002 7.56575 40.6778 12.4019 9.60944 38.6013 +6913 4 39.712 8.14959 41.3779 4.03526 -4.70584 -30.6789 +6914 4 40.8329 7.16354 41.1893 -8.78874 -6.51591 -16.4763 +6915 6 6.89044 6.83556 10.7869 16.1514 15.8461 -3.23426 +6916 4 7.31622 7.70217 10.5979 -16.164 -15.6489 3.8938 +6917 4 7.04178 6.69918 11.735 -3.2221 -0.411834 -4.21297 +6918 6 31.2643 6.58983 20.136 22.5576 -57.6677 6.94967 +6919 4 30.6637 5.92034 20.5005 -2.47046 2.78164 8.35653 +6920 4 30.7152 7.30056 19.9711 -35.0351 52.1138 -11.6241 +6921 6 54.5411 21.0454 27.2925 4.1013 -43.0328 84.8338 +6922 4 0.071192 20.2129 27.5399 -15.6737 30.1382 -21.2093 +6923 4 54.6532 21.3072 26.4181 12.1035 8.54749 -60.3726 +6924 6 4.75213 23.1508 16.2245 -49.4139 4.34438 -28.0546 +6925 4 4.2471 24.0009 16.1592 20.3634 -17.2761 5.59937 +6926 4 5.4972 23.3136 16.7675 27.2932 5.42097 22.4316 +6927 6 25.5515 11.0241 14.8358 9.2665 0.546345 5.2197 +6928 4 26.0976 10.3608 15.3182 -9.73323 12.0118 -14.516 +6929 4 25.8683 11.8947 15.1133 0.0398252 -5.90721 -2.6003 +6930 6 41.1974 41.7784 29.942 -27.7855 -7.97533 -10.6302 +6931 4 40.9203 40.8727 29.6366 8.3922 29.767 6.72032 +6932 4 40.4023 0.465719 29.8931 18.9924 -15.525 2.17149 +6933 6 52.2793 15.2936 41.6313 19.4314 -9.06844 -20.2837 +6934 4 51.991 15.9601 0.331443 -10.9307 10.9541 10.4228 +6935 4 51.6032 14.6231 41.5544 -13.8311 -6.7739 0.824233 +6936 6 37.7418 21.7882 37.8505 9.73059 24.2058 3.49681 +6937 4 37.8176 20.8655 37.6583 6.26781 -24.8638 0.142384 +6938 4 38.1128 21.8753 38.7352 0.661952 0.248137 2.40564 +6939 6 23.8436 9.73697 27.5598 -17.3101 -56.824 -21.1542 +6940 4 23.6823 8.97924 26.8635 13.0753 42.6322 38.797 +6941 4 23.3674 9.48178 28.3892 6.27388 8.11738 -19.7561 +6942 6 43.0121 28.0431 32.8137 29.5034 -18.022 1.83467 +6943 4 42.9555 27.148 33.1715 -16.7807 6.42622 4.12236 +6944 4 43.9561 28.0675 32.5908 -15.6612 14.0802 -2.62256 +6945 6 34.1451 21.2362 11.9042 -10.4207 -39.0944 -3.26361 +6946 4 33.7785 20.3444 12.1585 8.75301 27.3815 0.918114 +6947 4 33.7383 21.3833 11.0382 -2.92284 10.3561 2.31655 +6948 6 10.5016 31.8267 10.0873 5.91889 6.7472 5.74276 +6949 4 10.9186 32.6594 10.3946 -11.2895 -14.4825 -9.55855 +6950 4 9.99233 32.0033 9.274 9.03923 7.50024 8.93884 +6951 6 35.8744 37.1309 22.1208 9.07655 -0.20125 -37.6945 +6952 4 36.7757 37.5102 21.9868 -16.2539 -8.14962 7.83623 +6953 4 35.5893 37.243 23.0078 -0.963312 7.56509 34.0991 +6954 6 27.293 4.59192 27.4599 -62.9251 -2.97268 8.43797 +6955 4 27.8573 4.63875 28.2367 1.75868 -0.322614 6.7695 +6956 4 26.3027 4.46726 27.7774 60.9698 2.85981 -12.9146 +6957 6 39.0165 22.2861 10.6525 -25.2911 9.99335 20.5692 +6958 4 39.5938 21.9801 9.97437 16.8498 -5.94336 -19.6369 +6959 4 38.1468 22.3658 10.2352 2.38909 -7.32087 0.337973 +6960 6 30.765 39.1813 10.9358 -26.8864 17.0789 0.421318 +6961 4 31.7273 39.1993 11.0368 0.254075 -10.0442 -6.8497 +6962 4 30.3957 38.288 10.8473 24.5485 -0.522695 0.476538 +6963 6 44.5972 26.9475 2.20695 17.6159 -27.9211 -0.145864 +6964 4 44.8477 26.0903 2.61727 -13.9349 20.2639 -7.87324 +6965 4 45.3006 27.0404 1.55025 0.322606 15.9 1.66232 +6966 6 23.7817 14.549 26.4845 -13.1218 37.1912 -28.6876 +6967 4 23.5085 15.1786 25.7375 18.3344 -26.327 26.4977 +6968 4 23.2314 13.7794 26.3439 -3.10125 -8.02717 6.138 +6969 6 38.3349 13.3785 39.6531 51.0719 11.8768 18.627 +6970 4 39.1134 13.8424 40.1004 -28.3003 -20.0613 -21.9332 +6971 4 37.637 14.0102 39.7945 -20.9869 -1.09015 1.55638 +6972 6 17.9076 17.2343 29.3998 2.5182 -11.8623 9.07057 +6973 4 17.7005 16.8028 28.5679 -0.208052 -3.06359 -6.42367 +6974 4 17.2973 17.9612 29.4206 -13.3644 14.2602 6.84169 +6975 6 17.427 29.8312 9.9167 5.70667 9.14636 11.5297 +6976 4 16.5259 29.8398 9.63655 -18.5043 -5.93208 -2.5299 +6977 4 17.9097 29.6705 9.11934 16.3543 -3.78316 -10.6623 +6978 6 35.6302 6.05705 19.6249 -12.632 -1.17761 -30.1407 +6979 4 35.1756 5.57436 18.904 4.12491 -0.359791 14.6292 +6980 4 35.7342 6.9119 19.1826 9.40393 1.91765 12.7562 +6981 6 18.674 22.2857 17.523 8.42296 3.39096 21.1197 +6982 4 17.7402 22.4481 17.6821 -9.17854 0.615652 -6.61815 +6983 4 18.8674 22.3747 16.5992 -7.41694 3.44878 -20.9034 +6984 6 20.0258 3.81405 32.2871 -5.45876 10.2161 0.982716 +6985 4 19.684 4.03807 31.424 -2.67861 3.00481 -7.64614 +6986 4 20.9375 3.54321 32.099 -1.59169 -5.33194 9.42598 +6987 6 5.47094 6.98417 8.10987 -1.95658 -27.204 5.03178 +6988 4 5.85072 7.84658 8.088 3.96324 28.039 -6.11929 +6989 4 5.94584 6.55919 8.82772 -3.50663 -6.33739 10.9422 +6990 6 44.182 20.5312 25.5979 43.1361 -13.705 -19.148 +6991 4 44.6875 21.1042 26.1493 -15.9255 27.6084 29.7698 +6992 4 44.9726 20.2272 25.1253 -26.0739 -14.4287 -20.9555 +6993 6 43.9621 36.9892 17.8709 27.7049 17.1418 -9.42399 +6994 4 44.6647 37.4643 17.3692 -13.724 -4.61297 12.4448 +6995 4 43.6121 36.3808 17.225 -14.1002 -14.0328 0.985329 +6996 6 34.6183 10.1148 16.2555 -4.96303 14.2933 -37.1542 +6997 4 34.4099 10.1014 15.264 7.63186 -7.52385 38.4141 +6998 4 34.6455 11.0716 16.4378 1.03434 -4.81203 3.48645 +6999 6 23.6535 3.43617 1.32551 9.32991 -27.0385 -60.023 +7000 4 23.5361 2.47498 1.09872 1.70789 26.2755 24.74 +7001 4 23.8607 3.79652 0.414552 -11.3127 6.44054 37.9529 +7002 6 33.4225 38.9606 5.09116 -45.0556 15.9463 14.7537 +7003 4 32.9187 38.171 4.91655 10.2233 -24.4058 -4.43744 +7004 4 32.6531 39.5198 5.39063 34.9247 3.3662 -8.43025 +7005 6 22.5542 32.508 35.8091 -1.62577 21.6885 -22.4452 +7006 4 23.4313 32.1432 35.8321 13.5304 -8.64793 9.08541 +7007 4 22.6972 33.4304 35.4917 -7.91418 -12.6316 15.6694 +7008 6 32.4209 37.2696 13.8263 22.6153 37.4816 -15.7005 +7009 4 31.6314 36.8608 13.5507 -35.0264 -17.3769 -13.0658 +7010 4 32.7321 36.7183 14.5153 12.3601 -27.6025 17.2047 +7011 6 52.6048 12.7515 39.5965 -13.8302 -6.28036 -1.32475 +7012 4 53.26 13.3571 39.2655 9.70847 9.80763 -6.22213 +7013 4 53.0114 12.2827 40.3245 7.10516 -3.61819 3.538 +7014 6 28.8284 14.5654 1.23244 38.3097 18.383 -14.9432 +7015 4 28.2834 13.8143 1.34735 -23.3809 -22.0338 3.15251 +7016 4 28.3672 15.33 1.56727 -9.74512 0.414323 3.22557 +7017 6 1.45359 32.4205 23.3989 -1.05001 -40.1011 -18.1189 +7018 4 1.47013 31.5606 22.9188 -1.41837 10.7967 19.8874 +7019 4 1.97354 32.9442 22.8182 11.5552 29.203 -12.5869 +7020 6 54.3296 23.3325 28.9716 1.50467 4.34178 0.834044 +7021 4 54.2574 22.8567 29.7964 -0.193368 0.82753 11.1745 +7022 4 54.4723 22.6371 28.331 0.325397 -5.40149 -8.07104 +7023 6 14.3127 12.1509 35.6633 -33.5663 -10.8168 -13.6472 +7024 4 14.2878 12.7047 36.4184 6.74358 21.3133 20.6565 +7025 4 15.1756 11.8015 35.6107 35.8459 -8.25269 -4.05635 +7026 6 18.9986 6.53226 41.2771 -21.1361 -24.8418 -24.3627 +7027 4 18.366 5.78703 41.1105 9.63211 18.6573 18.8829 +7028 4 19.3119 6.48514 0.272589 3.11598 2.01554 11.5533 +7029 6 5.32991 17.8836 20.3428 -30.4167 16.0599 6.69424 +7030 4 4.7967 18.411 19.709 2.93149 -9.05217 4.33299 +7031 4 4.77097 17.8526 21.1546 15.0176 4.61027 -13.5236 +7032 6 24.7236 34.9657 30.1688 -3.59195 -26.0802 -14.261 +7033 4 24.7803 35.9013 30.0428 5.00342 21.1487 3.94382 +7034 4 24.6904 34.5809 29.2706 1.13339 13.2018 12.9935 +7035 6 31.868 4.6188 18.1813 26.0749 -11.7783 -2.21043 +7036 4 31.7807 5.26575 18.8694 -2.85928 14.415 8.06415 +7037 4 31.0011 4.54965 17.8036 -17.7428 -0.954819 -5.29079 +7038 6 8.70915 17.4782 5.92977 -5.10088 36.478 0.166614 +7039 4 7.99285 18.1665 5.8727 10.0003 -20.7449 -0.10219 +7040 4 9.53277 18.014 5.87919 -8.17468 -12.6369 7.06335 +7041 6 29.8448 10.9674 14.467 -9.24737 10.8237 6.24964 +7042 4 29.3518 11.4625 13.8111 -3.5417 -3.22768 -11.9456 +7043 4 29.8741 11.602 15.1948 7.6561 -6.41884 12.5924 +7044 6 48.7193 10.2987 32.5837 48.7914 -16.5053 -5.27468 +7045 4 48.664 9.84191 33.449 -1.5926 15.0761 -9.20872 +7046 4 49.6917 10.1556 32.2801 -49.2626 10.4163 8.33251 +7047 6 8.33128 15.6672 37.865 4.36755 4.12409 -33.9682 +7048 4 8.08142 16.0688 38.661 -6.22033 14.9054 48.1983 +7049 4 7.78443 16.1766 37.2488 7.82296 -4.92397 -7.06368 +7050 6 50.3849 3.07587 17.3306 53.0616 0.797084 -5.54454 +7051 4 49.9901 2.96071 16.4818 -23.7547 4.5323 -14.3202 +7052 4 49.831 3.21284 18.0832 -29.2444 4.71684 15.357 +7053 6 14.687 38.3962 10.9034 11.8452 2.26847 -28.7684 +7054 4 14.4993 38.5723 11.8231 -13.1425 0.700252 11.382 +7055 4 14.2628 37.5785 10.602 -2.45756 1.24341 13.1034 +7056 6 34.1174 6.37976 10.8168 12.9161 5.50138 13.5595 +7057 4 34.1292 7.23477 10.3416 2.23773 -14.4836 1.59416 +7058 4 34.9287 6.34152 11.3848 -14.7297 9.70771 -12.8953 +7059 6 7.1619 37.5492 17.6341 50.2032 -5.81562 0.15107 +7060 4 8.17599 37.5098 17.465 -47.7372 -0.307972 7.49553 +7061 4 7.05745 37.0565 18.4805 -8.53445 9.44148 -12.9936 +7062 6 51.515 11.3168 16.7982 -26.0757 5.86397 -27.0874 +7063 4 52.235 10.8459 17.1551 30.0977 -19.3818 20.7126 +7064 4 51.5008 11.0547 15.8562 -2.22905 10.0255 8.80825 +7065 6 15.6633 8.64974 3.19872 2.04011 -21.0584 -36.8111 +7066 4 15.359 9.2987 3.81038 -7.3063 19.0886 25.5551 +7067 4 16.1924 8.00887 3.67257 5.32849 -2.14206 7.59436 +7068 6 5.43671 21.4488 11.9213 -35.1135 30.2715 2.68526 +7069 4 5.1197 22.3031 11.5306 26.1226 -15.3225 -1.30607 +7070 4 4.71321 21.2794 12.5494 12.8867 -7.97314 3.40019 +7071 6 50.1888 24.041 37.9733 -16.5158 11.6838 -8.72192 +7072 4 49.5513 24.2503 37.2525 13.6843 -9.6942 16.9361 +7073 4 50.7608 23.3204 37.7156 0.52347 -2.66969 -5.08066 +7074 6 39.7366 11.2383 31.6978 23.7892 31.0409 -10.9794 +7075 4 40.3477 11.919 31.322 -8.85632 -23.7146 9.45819 +7076 4 38.8907 11.643 31.516 -11.7678 -2.00245 1.00495 +7077 6 26.6862 10.831 20.5846 -4.64528 13.8134 22.6501 +7078 4 26.37 11.3609 21.3584 5.46785 -6.26709 -23.7021 +7079 4 26.5097 9.94471 20.9062 3.28762 -9.42115 -6.7075 +7080 6 12.5617 17.5693 18.1619 57.3415 -16.6047 -35.4946 +7081 4 12.3732 16.6356 17.927 -10.1847 12.7431 11.2408 +7082 4 11.9536 17.9401 18.7496 -47.3477 6.23269 31.2745 +7083 6 47.7779 31.603 17.3345 -16.0229 -2.6295 -18.0517 +7084 4 48.4774 31.3981 17.9449 0.342859 -12.7175 10.4199 +7085 4 47.3751 30.7658 17.0144 6.51745 15.1025 2.87388 +7086 6 1.06661 3.38166 18.5387 0.482315 1.39351 -20.5486 +7087 4 1.47214 3.81044 19.3024 -7.19452 2.23946 8.83247 +7088 4 0.121217 3.21323 18.6865 2.92702 6.89788 10.7589 +7089 6 26.5916 20.3882 15.3141 4.05487 -19.1164 -7.10575 +7090 4 27.0276 19.5492 15.0037 -7.93965 16.9744 10.3813 +7091 4 25.6772 20.1067 15.4922 9.40368 -0.641397 -3.80974 +7092 6 42.0092 3.03717 36.7607 9.58516 7.42569 -27.539 +7093 4 41.472 2.27114 36.5289 -4.68032 -10.5632 12.6255 +7094 4 41.9749 3.27199 37.6769 -10.2045 -8.66607 25.0137 +7095 6 39.3197 22.4482 33.2161 17.1359 -6.1719 -1.11969 +7096 4 39.6777 22.5385 34.1471 -14.6651 4.73191 -34.7467 +7097 4 39.2891 23.3308 32.7977 1.66572 -7.01471 12.3298 +7098 6 18.4983 34.959 11.9233 -52.4092 11.8234 -6.15541 +7099 4 19.3311 34.9297 12.2931 62.358 -5.27325 28.8625 +7100 4 17.9525 35.2018 12.6795 -15.7268 -2.39727 1.11957 +7101 6 22.849 14.1156 0.206953 9.43339 -22.8796 20.8561 +7102 4 23.1273 14.7687 41.4941 9.338 18.1693 -9.76493 +7103 4 23.4344 14.2183 0.991573 -8.36464 7.13735 -11.7533 +7104 6 31.0127 16.6435 33.7717 -75.3989 -12.3916 10.6429 +7105 4 30.4261 16.8588 33.0132 20.7291 0.745933 12.1228 +7106 4 31.8948 16.7604 33.5238 39.9201 13.7608 -15.1754 +7107 6 28.4056 35.5121 5.54765 -4.91817 12.0412 -0.933493 +7108 4 29.0647 34.8486 5.74161 15.0982 -5.96625 -1.02933 +7109 4 28.8561 36.3656 5.44297 -1.6946 -6.58589 1.12865 +7110 6 2.06022 31.4415 10.6404 20.6415 1.38777 10.2498 +7111 4 2.4899 32.1989 10.2195 -2.44284 -2.19106 -3.22737 +7112 4 1.13111 31.6267 10.6164 -17.6565 -0.143118 -7.1498 +7113 6 5.95467 9.75858 21.3545 2.17354 8.87983 -50.8842 +7114 4 6.2643 10.5435 20.7894 -11.3634 -34.5597 22.4005 +7115 4 5.48441 9.14719 20.7121 9.8282 23.6666 23.1144 +7116 6 24.7866 26.6177 2.6661 -24.4024 -28.5469 2.9707 +7117 4 23.9476 26.6963 2.18158 9.10826 11.4817 -7.6186 +7118 4 24.6214 25.7954 3.1805 15.5163 19.2379 2.11057 +7119 6 45.7515 4.24664 18.6084 -0.948574 6.19926 2.59566 +7120 4 46.4738 4.91595 18.5123 -9.05862 -19.7882 -0.326833 +7121 4 46.0843 3.34349 18.421 4.31178 15.089 3.21664 +7122 6 4.45878 0.783326 15.9106 20.8465 2.39674 -2.22601 +7123 4 4.33336 41.7534 15.8294 -11.1347 -14.3847 -2.31303 +7124 4 5.37758 0.813141 16.2285 -10.0444 13.1447 -0.149196 +7125 6 2.44065 19.4988 25.3899 -18.2163 -19.9205 28.2208 +7126 4 1.89428 18.9873 26.0273 4.60516 17.0002 -8.33323 +7127 4 2.55045 18.8717 24.6878 9.48029 -1.77855 -17.0048 +7128 6 40.6027 8.48954 5.10826 -27.6355 -21.4881 -13.6167 +7129 4 40.6592 9.31425 5.57088 10.9479 16.5697 14.8472 +7130 4 41.3781 7.96424 5.30637 14.4251 2.68711 -2.52113 +7131 6 49.3092 22.3481 41.5186 -9.93734 74.0457 16.0776 +7132 4 48.4971 22.7919 41.1786 21.3857 -10.289 -0.267672 +7133 4 49.2285 21.4633 41.2985 -4.59952 -62.95 -16.8011 +7134 6 0.364483 40.9333 20.5966 -24.8933 -11.8265 -30.66 +7135 4 0.190818 39.9667 20.5681 4.35782 8.08342 1.06674 +7136 4 54.6936 41.3396 19.9676 13.1862 -7.22974 19.6204 +7137 6 34.8864 15.3279 38.0452 -17.1782 37.3505 -55.2903 +7138 4 34.2682 16.0872 37.9321 5.94042 -16.3876 6.60377 +7139 4 35.3697 15.4116 37.1797 -1.56134 -6.74346 24.1748 +7140 6 7.76223 25.9987 29.8652 25.7268 -8.51605 -4.95409 +7141 4 8.61839 26.4638 29.9588 -13.1921 -1.71741 1.7916 +7142 4 8.05672 25.0651 29.9772 -19.4202 16.3818 3.54783 +7143 6 40.7182 22.7954 20.4441 37.8127 13.8011 -33.8007 +7144 4 41.3586 23.4588 20.0133 -28.9149 -26.2189 23.8294 +7145 4 40.2017 23.2969 21.0583 -10.7099 15.3396 13.8501 +7146 6 37.6932 25.6399 36.0638 4.62997 10.0285 35.1853 +7147 4 38.3287 24.9236 36.1183 -2.20273 -4.01008 -9.65359 +7148 4 37.2914 25.6394 35.2107 -7.09628 -5.12362 -31.4654 +7149 6 5.46101 24.0014 10.2586 17.9799 16.5872 6.22131 +7150 4 6.04134 23.844 9.49543 -11.5162 -2.35388 5.85767 +7151 4 5.90746 24.7967 10.672 -23.415 -30.7572 -16.8601 +7152 6 48.4104 21.0451 38.1819 10.5351 27.9197 -28.7006 +7153 4 48.793 20.7803 39.017 13.2175 -6.38321 0.209366 +7154 4 49.1228 21.3802 37.5459 -28.8109 -18.4864 30.6779 +7155 6 15.2906 25.011 3.54101 2.70625 6.69817 -9.95824 +7156 4 15.4569 24.0555 3.50682 -9.52162 -0.514188 6.9158 +7157 4 14.6826 25.2483 4.2581 -1.83637 -10.9582 1.3864 +7158 6 46.3949 40.2718 20.0841 3.05266 -42.5213 0.389481 +7159 4 46.7282 39.319 20.1688 -17.5494 37.8624 -2.40649 +7160 4 47.138 40.8016 20.3323 14.2597 18.5668 -0.122304 +7161 6 34.6662 36.4732 0.324161 -52.0076 35.1593 -1.38074 +7162 4 34.82 35.9689 1.09464 17.4812 -18.6855 30.1307 +7163 4 33.7817 36.8781 0.601954 33.7085 -7.09846 -24.72 +7164 6 52.5968 8.00424 30.4116 -30.791 -5.83914 -1.44892 +7165 4 52.0396 8.66036 30.8559 12.8564 7.40177 -0.477247 +7166 4 51.9287 7.58179 29.8369 22.2614 -6.63703 0.63559 +7167 6 32.0772 3.86049 29.4688 -16.0025 -7.01815 -35.05 +7168 4 31.5382 3.03776 29.5615 20.8838 14.671 -1.22835 +7169 4 32.0904 4.03293 28.4798 -1.86833 -11.5506 40.3284 +7170 6 20.363 17.8245 28.646 3.47804 13.7512 -7.92665 +7171 4 19.5516 17.4966 29.0653 6.53113 9.74715 -6.36853 +7172 4 20.0825 18.3002 27.8308 0.555567 -8.90179 15.8758 +7173 6 30.4041 41.1634 41.0132 -16.7253 12.0993 -9.83452 +7174 4 30.5197 40.835 40.1072 4.71307 -5.7925 7.34595 +7175 4 31.1703 40.9637 41.5368 18.7313 -7.07732 1.06037 +7176 6 35.4542 32.8539 27.9215 21.6406 26.5455 -21.3275 +7177 4 35.1435 33.2362 28.7432 -6.21594 5.85967 7.97646 +7178 4 35.8745 33.6007 27.3754 -13.2283 -32.0923 16.9769 +7179 6 14.39 6.67952 12.731 -12.5058 36.491 0.424373 +7180 4 15.2321 6.28981 12.9462 8.74388 -6.1299 -2.75421 +7181 4 14.5067 7.66796 12.7988 -3.69921 -34.1177 -6.56265 +7182 6 41.8739 41.5433 20.319 24.4238 12.2951 6.29746 +7183 4 42.7192 41.2715 19.9184 -11.0628 6.38436 -6.30872 +7184 4 41.3184 40.7767 20.2955 -10.4459 -12.1473 -5.48062 +7185 6 46.3985 22.5739 8.8638 6.84921 19.3184 1.79378 +7186 4 45.8729 21.8991 8.42669 -3.07803 -12.5032 3.12866 +7187 4 47.1271 22.1566 9.33065 -8.50589 -8.34396 1.5145 +7188 6 17.4023 20.6526 13.9004 10.6995 28.5611 -11.4854 +7189 4 17.6978 21.6036 13.9579 -8.84666 -31.3302 7.07381 +7190 4 17.3123 20.5004 12.9448 0.490636 -3.23538 4.08121 +7191 6 8.20126 9.48382 13.3485 -42.4293 41.8522 17.2798 +7192 4 7.44487 10.0964 13.6076 19.5538 -29.8853 -13.4391 +7193 4 8.9576 10.0119 13.6277 13.7224 -9.45646 -1.54211 +7194 6 7.58554 14.8008 29.5824 -2.61798 9.90858 -2.64866 +7195 4 7.05733 14.3538 30.2458 -0.514214 1.68252 7.63674 +7196 4 7.01989 15.5029 29.2149 4.91731 -6.06465 -0.976267 +7197 6 29.5668 39.2268 22.6285 -3.66094 -2.39634 13.3419 +7198 4 29.8353 38.7557 23.4169 -4.20308 -7.76017 12.2752 +7199 4 30.3745 39.2765 22.1369 12.5997 4.36069 -18.8462 +7200 6 19.725 28.7952 8.44488 15.8543 2.58223 -4.45186 +7201 4 19.5131 27.8757 8.63421 -2.81313 1.38303 -4.16069 +7202 4 20.6983 28.808 8.54393 -13.7447 6.84799 3.59225 +7203 6 20.0995 21.6275 25.9249 -17.5249 50.4223 5.09745 +7204 4 20.7082 22.0204 26.5908 -8.84326 -18.264 -10.6066 +7205 4 19.3931 22.3347 25.9239 13.215 -30.9895 -3.48111 +7206 6 12.7711 16.1006 22.7986 17.0661 -2.75106 -3.7002 +7207 4 12.1316 16.7784 22.5952 -11.3059 6.43976 -4.8982 +7208 4 12.4647 15.3033 22.3372 -2.13756 9.04884 6.71194 +7209 6 7.09175 27.2069 17.991 -23.617 26.2366 -1.29155 +7210 4 7.8076 26.6007 17.9383 20.2011 -26.8554 -5.74897 +7211 4 7.19403 27.792 17.2318 3.33647 -0.0238245 -0.788587 +7212 6 32.3975 8.68618 34.8629 3.54321 22.8272 16.3539 +7213 4 32.7738 9.06402 35.707 -18.9002 -9.48773 -27.5474 +7214 4 31.4989 9.0701 34.6771 23.7457 -9.58556 9.46102 +7215 6 50.3515 28.2186 17.5351 -6.87553 0.519429 12.9107 +7216 4 50.2481 27.3572 17.999 6.5408 9.8464 -12.2276 +7217 4 51.0722 28.1417 16.8919 -2.26653 -7.3618 -1.59066 +7218 6 15.6741 32.1546 25.7968 -26.4348 -11.0143 -14.9159 +7219 4 16.4004 32.6083 26.1805 24.7846 13.6092 10.6573 +7220 4 15.1411 32.8481 25.3674 4.92309 -4.07512 11.5217 +7221 6 41.2877 22.001 29.6411 43.1174 -21.5596 15.2505 +7222 4 40.6305 22.5901 29.3541 -33.8214 23.827 -16.0773 +7223 4 40.8662 21.2212 29.998 -7.36398 -2.60921 4.02408 +7224 6 24.5416 12.7608 8.88206 5.17198 -11.9982 -20.3907 +7225 4 24.1774 13.5122 9.35398 1.69504 4.6425 -2.53241 +7226 4 24.2888 12.8675 7.94212 1.28664 -3.68024 15.0016 +7227 6 47.3025 20.1085 10.3977 1.21439 24.4816 37.2747 +7228 4 48.204 20.4596 10.4656 -0.7364 -8.12719 -10.3932 +7229 4 47.15 19.5905 9.61989 6.68365 -16.152 -23.0167 +7230 6 17.6916 14.2112 29.9613 0.736848 4.98565 -22.9932 +7231 4 16.8377 14.622 30.0672 -16.7241 9.37988 10.4211 +7232 4 18.1183 14.7557 29.2835 1.70081 -6.05446 6.16757 +7233 6 21.3481 34.5805 28.5342 -9.54463 9.82799 -20.865 +7234 4 21.5933 35.4178 28.0943 -1.05427 -4.62886 14.5387 +7235 4 21.7361 34.566 29.3968 13.4346 0.0141216 16.9261 +7236 6 35.1024 4.03924 4.01172 -45.5158 42.5484 12.3245 +7237 4 34.1858 3.89939 4.38295 32.1954 -12.7538 -7.33111 +7238 4 35.1016 5.02916 3.89259 9.91862 -26.8751 2.91657 +7239 6 29.9059 8.58368 22.6013 -13.5917 -22.6535 -48.6732 +7240 4 29.4773 8.30259 21.7189 15.3855 19.7125 42.6195 +7241 4 30.4378 7.8025 22.8052 -0.87874 9.41284 8.39762 +7242 6 9.78314 32.9658 15.9197 34.9354 -36.2496 39.6827 +7243 4 9.8463 32.0623 16.3137 -14.5131 14.3099 -26.4053 +7244 4 10.4229 33.3707 16.5321 -2.5459 17.7355 -14.0184 +7245 6 24.9212 14.2335 32.582 19.5351 -17.8621 25.1352 +7246 4 25.485 14.4356 33.3711 -14.9506 -0.509299 -20.0473 +7247 4 24.5508 15.0526 32.2925 -5.32053 16.7872 -6.18619 +7248 6 49.6539 21.965 26.2345 44.0267 25.2751 -8.97422 +7249 4 50.4399 21.435 26.5572 -22.3889 20.3635 -4.11669 +7250 4 50.0214 22.8598 25.9362 -18.5294 -37.2714 15.3372 +7251 6 39.2165 29.6282 28.7804 -1.72389 1.82743 -9.11301 +7252 4 39.3036 29.0201 29.5259 1.24025 -1.09654 1.55877 +7253 4 39.538 29.1266 28.0158 0.286751 -1.49672 5.82908 +7254 6 50.6899 34.7862 39.7499 25.3157 10.1005 12.0928 +7255 4 51.6472 34.6743 39.5192 -19.7186 -4.86584 -0.193213 +7256 4 50.1651 34.2508 39.1591 2.72681 -14.2758 -14.8682 +7257 6 29.2004 20.8742 19.5261 27.9811 -3.68804 20.7377 +7258 4 30.1466 21.1247 19.5553 -9.39276 -2.96688 2.79863 +7259 4 28.9246 21.1497 18.6738 -22.5466 15.5983 -24.0329 +7260 6 45.8438 1.42491 21.3861 -37.1737 6.40486 -10.0566 +7261 4 44.9885 1.11968 21.7285 6.97513 -0.0444158 -7.72874 +7262 4 46.4438 0.92117 21.8904 34.782 -15.8409 16.3481 +7263 6 26.1011 5.84859 12.9885 -16.9285 4.46913 -7.38549 +7264 4 26.5547 5.08441 12.6375 7.71787 -14.9735 6.0022 +7265 4 25.1614 5.66972 12.8036 4.71997 0.43883 -1.19571 +7266 6 9.00669 19.0403 23.7238 12.8928 30.373 -14.6892 +7267 4 8.06593 18.9071 23.7945 -12.9763 -5.98489 5.20443 +7268 4 9.0473 19.9093 23.2431 5.0983 -22.172 6.64837 +7269 6 47.6961 14.1782 40.0269 19.0377 9.97795 -11.4729 +7270 4 48.5222 14.3512 39.5239 -16.7083 -4.37767 10.6105 +7271 4 47.3795 15.0553 40.2888 -5.04524 -6.44815 -3.81417 +7272 6 47.9985 19.7874 0.500962 -66.9165 -27.0064 -39.4066 +7273 4 48.5513 19.9496 1.22397 26.1904 -2.55385 45.3318 +7274 4 47.2789 19.103 0.704655 34.6798 29.0788 0.973802 +7275 6 27.1606 39.6013 31.4318 -10.4761 -55.491 -38.6851 +7276 4 26.8926 40.2811 32.0159 -13.7359 20.3686 20.1783 +7277 4 26.3709 38.9998 31.2101 25.3937 25.349 18.055 +7278 6 20.7209 15.2822 27.3078 -0.805435 -7.71632 -8.78017 +7279 4 19.7876 15.3781 27.0487 8.25469 13.9731 2.34115 +7280 4 21.2532 16.0335 26.9925 -16.2498 2.55153 -4.46604 +7281 6 53.2722 3.12643 19.6849 41.3384 49.6686 7.26214 +7282 4 52.533 3.74254 19.7043 -8.02663 -2.92583 -3.0848 +7283 4 53.0086 2.23956 19.6703 -22.4403 -46.3419 -2.11618 +7284 6 40.7531 33.3786 24.0219 13.5521 -1.60379 23.9632 +7285 4 41.5067 33.1664 24.6167 -8.75803 3.71621 -14.936 +7286 4 40.1104 32.6626 24.1628 3.50492 2.6284 -2.95087 +7287 6 50.2066 37.8896 21.3771 44.4561 61.7722 -19.2089 +7288 4 50.9779 37.3435 21.496 14.3962 -14.5259 7.12428 +7289 4 49.4598 37.4098 21.5582 -59.0635 -51.549 13.7135 +7290 6 41.3233 2.3412 21.9924 -16.3503 12.7858 19.6024 +7291 4 41.3426 2.52207 21.0679 5.97541 2.4567 -21.4637 +7292 4 40.4663 2.75609 22.2585 17.532 -18.0725 0.252127 +7293 6 3.68867 21.2779 14.3383 -14.5707 42.5 -35.9941 +7294 4 4.12477 21.855 14.9587 9.56216 12.6885 8.47194 +7295 4 3.77328 20.4352 14.6935 9.76412 -50.205 23.6517 +7296 6 34.2782 11.1533 36.6146 -6.03132 -23.9347 13.7336 +7297 4 33.9924 10.5436 37.3334 13.9996 -4.78487 -21.5854 +7298 4 34.1172 11.978 37.0322 -7.62349 27.2634 9.28858 +7299 6 24.0533 21.9225 23.4615 4.73517 -5.47775 13.1649 +7300 4 23.9978 21.53 22.5886 6.00444 -6.53009 -8.74438 +7301 4 24.605 21.2935 23.9896 -10.4931 14.2472 -9.63662 +7302 6 18.8931 0.346665 4.41951 -1.70081 19.9518 7.76538 +7303 4 18.8368 41.3461 4.13842 4.04101 -8.25805 2.22226 +7304 4 19.3845 0.416823 5.25819 -4.2619 -8.11151 -12.0763 +7305 6 1.61167 7.82777 17.7295 14.4633 -7.55708 2.21629 +7306 4 1.68315 6.88308 17.5181 0.421421 7.02752 -3.81945 +7307 4 0.776664 7.94842 18.1735 -9.56642 1.01884 2.20602 +7308 6 9.88587 31.542 26.4865 27.4574 -58.0414 -32.6279 +7309 4 9.74723 30.8294 25.7579 9.18818 32.443 34.13 +7310 4 9.16596 32.1271 26.4328 -35.6644 31.0992 -1.66616 +7311 6 46.989 33.006 20.3636 -11.9681 -37.8677 44.1235 +7312 4 47.0707 32.5253 21.2626 7.56487 31.1056 -35.1941 +7313 4 46.435 32.3629 19.8924 4.61548 9.19147 -10.8851 +7314 6 49.5457 29.2916 21.3977 -38.7846 4.15079 -24.0209 +7315 4 50.3477 28.8236 21.2219 24.323 -7.55681 13.7085 +7316 4 49.5468 29.8542 22.1736 14.9668 -0.936193 10.2574 +7317 6 13.5153 31.8979 19.1528 13.8675 8.3184 29.6787 +7318 4 12.8458 31.9825 19.8587 16.0999 2.21739 -7.32054 +7319 4 14.3406 32.2634 19.5906 -25.0701 -6.26478 -24.6616 +7320 6 46.633 34.1066 16.9257 -0.036059 -36.1463 20.7227 +7321 4 46.8492 33.9929 15.9997 3.99258 8.43366 -10.882 +7322 4 46.9059 33.2223 17.3084 -4.9703 29.3867 -9.59361 +7323 6 19.7609 39.5392 2.42166 -7.20248 -0.896063 -14.0911 +7324 4 20.5606 40.0527 2.5788 -3.5749 4.99115 -1.28658 +7325 4 19.2738 40.0463 1.72337 11.6568 -15.7424 21.4794 +7326 6 16.5329 9.39795 28.3065 -12.6095 -8.72502 6.68605 +7327 4 16.4075 10.3536 28.3648 10.1088 3.80195 -3.74389 +7328 4 17.4502 9.20269 28.1082 11.2813 2.72217 -1.81406 +7329 6 3.0433 33.3643 8.96425 -4.92886 23.6682 -21.9772 +7330 4 2.41869 34.0757 8.74286 -2.57616 0.180013 17.6579 +7331 4 3.16376 33.0029 8.08154 7.55925 -16.3918 2.91827 +7332 6 49.6751 28.308 0.201579 -29.5359 7.30765 2.58258 +7333 4 50.5733 28.3754 41.8671 34.4717 0.327786 -9.88202 +7334 4 49.5726 27.4715 0.657175 -2.26504 -2.01296 8.34302 +7335 6 1.41619 6.84354 30.4994 -10.3235 0.0954103 3.42179 +7336 4 1.63397 7.74222 30.8225 4.19995 -13.4757 3.05915 +7337 4 0.761793 6.45905 31.124 14.5617 20.0187 -8.0296 +7338 6 19.7679 9.42131 33.717 -3.22882 -6.25654 -44.8315 +7339 4 19.9145 8.46604 33.7746 1.8774 1.59257 2.48781 +7340 4 19.5751 9.55831 32.7323 1.24521 6.76178 40.819 +7341 6 26.1724 11.919 3.61074 17.7641 10.7445 -19.8393 +7342 4 25.5356 12.1934 4.24073 -14.9718 14.8208 22.8097 +7343 4 26.0423 10.983 3.54915 1.55706 -20.7566 2.99847 +7344 6 33.2542 2.1444 18.2116 -1.15587 48.9982 3.93816 +7345 4 32.886 2.96086 18.6548 6.67205 -21.4839 -22.8104 +7346 4 32.6761 1.46025 18.493 -13.9253 -19.4899 6.26155 +7347 6 1.55797 29.1194 15.6221 -22.3111 36.2637 61.7506 +7348 4 0.853719 28.5449 15.936 -7.71843 6.28063 0.384394 +7349 4 1.90648 28.6788 14.9107 30.7784 -39.3832 -62.5327 +7350 6 41.7311 4.10421 39.5944 -40.7328 36.7616 -42.7174 +7351 4 41.3817 4.81242 38.923 27.6667 -38.3892 36.6931 +7352 4 40.9025 3.64602 39.8145 11.2401 -8.56921 5.26404 +7353 6 28.6823 41.7982 21.1955 47.2047 1.42594 -8.59686 +7354 4 29.177 0.720645 21.3267 -21.6507 -0.473723 0.486784 +7355 4 29.4617 41.2314 21.0003 -26.4876 -3.65191 3.02858 +7356 6 11.643 12.3982 35.4482 -35.2927 22.3423 -20.2863 +7357 4 11.5968 12.2307 36.3713 6.75035 -5.55932 30.2124 +7358 4 12.5522 12.401 35.2267 32.0712 -2.0845 -6.40416 +7359 6 9.80556 12.056 0.297197 42.0735 31.0338 -28.3715 +7360 4 10.6577 12.4693 0.65483 -33.0881 -22.384 -10.4034 +7361 4 9.20254 11.76 0.941289 -12.1624 -10.8407 36.4861 +7362 6 48.1632 12.393 9.2137 2.43833 7.21341 -5.5951 +7363 4 48.4522 11.811 8.50685 -9.57081 -7.25037 -8.94466 +7364 4 48.8896 12.3474 9.83523 7.41749 2.43397 12.8852 +7365 6 20.1331 24.378 18.9556 11.9182 2.36756 -38.9603 +7366 4 19.4372 23.8368 18.5171 17.2732 8.77886 9.60074 +7367 4 20.7988 24.6336 18.2364 -23.7637 -10.2166 26.3276 +7368 6 16.5494 31.2838 16.4573 -15.9423 3.69088 33.2062 +7369 4 16.5519 32.1922 16.7594 11.1434 16.9832 -11.781 +7370 4 16.1476 30.8867 17.2522 1.55385 -15.8871 -15.2552 +7371 6 1.78983 14.6435 36.2904 4.99553 5.58283 2.2492 +7372 4 1.04893 14.2282 35.8708 -13.8588 -3.35469 -16.6141 +7373 4 1.66905 14.392 37.2023 2.39459 2.07051 19.2387 +7374 6 4.37166 29.2153 29.5914 5.79168 20.1405 -19.3585 +7375 4 4.91557 28.7254 30.2154 7.17051 0.117226 5.39869 +7376 4 4.91513 29.9512 29.1891 -14.7291 -26.607 12.32 +7377 6 43.6969 0.237019 22.6594 -7.19613 -4.49497 -5.57098 +7378 4 43.0237 0.783547 22.2316 -12.2242 -6.81623 2.03469 +7379 4 43.4415 41.2053 22.5454 5.15142 14.113 -1.35906 +7380 6 52.5052 40.9917 27.2414 -4.0762 -16.2903 -30.037 +7381 4 52.8129 40.7577 26.3208 -10.5132 10.5144 20.9332 +7382 4 53.295 41.2999 27.6882 6.37269 9.42971 1.77711 +7383 6 25.5785 23.9088 27.7352 -29.163 -0.147769 2.09076 +7384 4 24.7169 24.3904 27.6009 26.0068 -16.0483 4.45096 +7385 4 26.303 24.4711 27.4736 4.98376 5.99744 -3.44082 +7386 6 23.1322 17.0409 33.3147 -4.87562 4.34963 6.5261 +7387 4 23.1435 17.5188 34.1474 -0.665908 -2.26574 -1.07751 +7388 4 22.9237 16.1327 33.5379 -5.85649 -9.89669 4.05086 +7389 6 2.9235 11.8719 21.3628 -62.5775 -31.8178 -28.2901 +7390 4 2.1985 11.2347 21.6738 31.4392 30.9604 -16.9464 +7391 4 3.51176 11.9111 22.066 35.7266 4.49799 37.8533 +7392 6 2.17958 4.14491 30.0321 9.06251 -9.53771 -13.2585 +7393 4 2.15165 5.09682 30.107 -1.56529 16.7016 0.150815 +7394 4 2.7299 3.97467 29.2422 -7.5281 0.377543 4.10315 +7395 6 26.6694 30.2855 13.4776 10.1196 11.7228 27.7054 +7396 4 25.7357 30.4785 13.6549 -0.51692 -11.2356 -3.98914 +7397 4 27.0778 30.3597 14.373 -6.55394 -4.70072 -25.9179 +7398 6 24.8731 30.8123 10.8246 -35.9544 -8.06722 -7.65859 +7399 4 25.2097 30.0125 10.4324 5.41746 -9.73411 -7.41209 +7400 4 25.6149 31.228 11.1936 31.2673 18.7081 18.3938 +7401 6 53.1638 24.1184 4.51161 -10.4445 -35.9395 21.0824 +7402 4 53.5233 24.7957 3.98549 14.2054 30.1141 -21.0763 +7403 4 53.9237 23.6117 4.81383 2.71167 2.31883 7.09562 +7404 6 24.8958 4.51213 23.9931 -29.6363 -43.6073 15.3227 +7405 4 24.1339 5.1036 23.9039 18.5944 16.8193 -2.99678 +7406 4 25.7258 4.88904 23.7461 22.8138 27.5954 -9.18982 +7407 6 34.6838 1.65591 41.2514 12.8053 -23.083 -29.6978 +7408 4 35.6244 1.45761 41.0729 -14.4971 0.421146 -0.177754 +7409 4 34.7301 1.99199 0.211928 -2.47028 17.9107 34.9925 +7410 6 13.312 19.5249 16.387 18.9594 -19.3284 17.3248 +7411 4 13.9333 19.1674 15.7225 -9.24732 -4.9188 0.52103 +7412 4 13.2597 18.8166 17.0929 -3.23838 18.5958 -24.3952 +7413 6 48.698 0.181353 20.409 -0.21633 -26.9433 -24.4133 +7414 4 49.103 41.5184 19.698 -4.34753 24.5911 30.5043 +7415 4 48.7986 41.623 21.2469 8.80211 1.41451 -0.511645 +7416 6 43.0644 27.7916 11.5133 -14.5871 -6.12813 -9.0892 +7417 4 42.6 28.0105 10.6776 10.2055 -1.97818 11.3293 +7418 4 43.4908 28.591 11.8257 3.55806 4.66568 -1.20709 +7419 6 25.6909 21.365 35.1834 16.6334 21.4278 -26.2382 +7420 4 25.8486 22.0441 34.4664 -6.54449 -15.4554 28.1071 +7421 4 25.5413 20.5536 34.6727 -4.24699 7.33591 15.2905 +7422 6 44.7232 4.60607 27.7619 9.66663 0.618053 -4.25407 +7423 4 44.3234 4.00717 27.1079 -6.11804 2.34462 0.765623 +7424 4 44.3971 5.50639 27.5932 -3.06611 -6.30885 -0.545657 +7425 6 41.2897 11.4432 34.2066 -9.61739 21.0206 -8.56292 +7426 4 40.6842 11.5664 33.4581 3.14959 1.41378 -1.0752 +7427 4 41.1924 10.5195 34.3892 0.589219 -23.8889 7.33677 +7428 6 19.897 36.6492 2.04794 -32.5825 5.5481 -21.6378 +7429 4 20.6399 36.2361 2.4987 10.0826 10.558 0.716761 +7430 4 19.9026 37.6342 1.97212 14.9366 -15.8518 15.2433 +7431 6 27.4836 4.66736 6.35028 2.97665 -65.4375 -50.0742 +7432 4 27.6123 3.82169 6.79207 -3.46759 -4.72632 -9.32934 +7433 4 27.4741 5.24116 7.04108 -4.39889 64.7262 58.0755 +7434 6 16.8382 30.7844 39.9326 10.6925 -56.0648 15.7324 +7435 4 17.0186 31.2572 40.7403 -2.33579 15.7179 12.0581 +7436 4 17.0831 29.8382 40.1617 -5.04661 27.4351 -11.6424 +7437 6 51.1641 15.1933 16.3324 21.7581 16.0625 -9.079 +7438 4 51.121 16.0888 15.8936 10.5188 -25.5533 9.6052 +7439 4 52.0677 14.7794 16.1385 -37.3149 17.1399 3.28502 +7440 6 49.9904 21.2241 35.9744 20.9503 -33.7397 19.542 +7441 4 49.3714 21.5088 35.3291 -23.4605 10.1211 -23.8745 +7442 4 49.9121 20.2362 36.0002 2.40052 26.2853 0.00810801 +7443 6 34.428 0.14016 5.66944 -7.82493 37.3161 8.31948 +7444 4 34.304 0.843366 6.34479 2.68801 -11.9822 -16.4886 +7445 4 34.2591 0.582485 4.80419 9.04141 -16.6905 11.7821 +7446 6 48.3182 11.536 19.8764 -48.9228 13.3726 26.2823 +7447 4 47.7285 11.3649 20.663 34.2262 -2.74449 -19.9886 +7448 4 47.7235 12.1441 19.3775 23.4884 -14.873 -2.11476 +7449 6 4.19152 39.4305 13.3555 27.463 28.0369 44.5079 +7450 4 4.88401 39.7456 14.019 -21.6239 -15.7277 -33.754 +7451 4 3.37287 39.6897 13.8148 -3.76347 -10.7833 -11.4512 +7452 6 8.74995 16.191 8.53596 -5.05856 2.64204 -21.058 +7453 4 8.7323 16.8633 9.22906 0.669847 -0.203387 -6.91741 +7454 4 8.69158 16.6347 7.64451 3.76071 -7.46014 24.9197 +7455 6 29.0285 14.2822 26.5262 -5.84817 34.0816 17.5192 +7456 4 29.0044 15.2824 26.745 3.30971 -49.1818 -9.92417 +7457 4 28.1563 13.9159 26.7584 2.39554 12.59 0.416474 +7458 6 27.3852 14.5292 8.14264 -25.3608 8.37865 0.80053 +7459 4 26.4121 14.3996 8.08331 21.4517 0.6706 1.76752 +7460 4 27.495 15.4908 8.29449 3.73212 -17.2528 -1.50339 +7461 6 14.1265 27.2071 32.922 33.1666 19.82 -10.1122 +7462 4 14.9257 27.349 33.4618 -9.56175 -2.66902 -6.75133 +7463 4 13.49 26.8422 33.5082 -21.5238 -13.7689 15.9353 +7464 6 31.6534 35.7886 21.2701 -36.804 -37.663 0.546332 +7465 4 32.1208 36.3742 21.8378 9.4961 28.0075 13.3964 +7466 4 30.8651 35.4592 21.7961 25.8489 11.2411 -16.1565 +7467 6 54.2152 28.7064 16.8886 2.86275 11.2554 8.9719 +7468 4 53.522 28.534 16.2345 -0.160695 -4.94794 5.34414 +7469 4 54.0581 29.6054 17.2296 -4.68599 -7.1814 -6.41975 +7470 6 9.06113 5.28333 17.1437 22.8853 4.22723 -20.1716 +7471 4 9.91678 5.17464 16.6036 -37.1561 0.754494 23.2593 +7472 4 8.77829 6.22091 17.0709 7.89423 -13.2605 2.73354 +7473 6 29.6746 9.78112 26.5507 33.4729 -21.3737 16.6755 +7474 4 30.5187 9.26436 26.5785 -19.9088 14.0899 -1.39861 +7475 4 29.3838 9.79264 27.4752 -2.64272 0.36338 -0.771294 +7476 6 44.0224 31.1718 32.1785 -15.3292 -7.28341 -3.2168 +7477 4 43.2245 30.9732 32.7283 18.2556 6.42044 -7.39667 +7478 4 44.6106 31.7763 32.6435 0.791193 1.46174 13.5451 +7479 6 53.5017 3.62335 25.1421 -16.9806 -9.67341 -1.19546 +7480 4 54.1073 4.37139 25.2408 5.33888 -0.871569 -8.36925 +7481 4 53.4976 3.25444 24.2353 14.6771 10.8199 10.1585 +7482 6 12.4523 22.8699 3.37515 20.8696 32.0548 51.3092 +7483 4 12.8715 22.0381 3.24611 3.69599 -28.8916 -15.1378 +7484 4 11.7545 23.0169 2.77653 -28.9409 -2.61743 -32.5554 +7485 6 39.4163 29.6883 0.716973 23.965 14.7498 -4.51132 +7486 4 39.9876 29.0776 0.254063 1.0023 1.05593 -7.22278 +7487 4 38.7356 29.138 1.03498 -27.9991 -12.2746 11.9106 +7488 6 13.7523 37.8126 23.0391 19.0421 33.8918 15.0049 +7489 4 14.5819 38.1972 23.3968 -5.92503 -31.5844 -9.82397 +7490 4 13.2717 38.649 23.0641 -23.8611 -10.9328 -14.9892 +7491 6 33.3489 41.2294 0.00543 12.0778 19.0207 4.12226 +7492 4 33.8966 0.076279 41.545 -17.8654 -16.3366 26.9287 +7493 4 33.5442 41.0956 0.968664 -4.79835 4.63337 -24.688 +7494 6 15.7246 3.52046 6.32841 10.9162 -8.85937 41.3038 +7495 4 14.9211 3.23468 6.78447 -0.787572 2.77727 3.3355 +7496 4 15.4617 3.69817 5.45032 -11.5336 7.63209 -33.5323 +7497 6 27.7759 30.762 5.08277 5.52432 -34.0682 -16.3389 +7498 4 28.5998 30.6312 5.57248 -10.7862 7.58152 2.34054 +7499 4 27.6688 29.856 4.68367 -5.5152 22.3618 6.77689 +7500 6 13.3283 7.58248 23.3427 28.3072 -1.43357 14.0598 +7501 4 14.1858 7.86415 22.9596 -10.8574 -4.57961 9.77565 +7502 4 12.7328 7.50745 22.6198 -18.1881 0.025746 -17.8687 +7503 6 38.3062 37.3234 27.9933 -3.63803 -3.21002 47.0561 +7504 4 38.1692 37.3862 27.0673 7.32148 -0.46048 -39.7323 +7505 4 39.0245 36.7163 28.2248 2.26391 -1.88339 -8.27891 +7506 6 35.8197 12.5511 12.093 -4.81482 -18.6185 14.0356 +7507 4 35.6024 11.6096 12.0486 2.81432 1.21601 -0.921604 +7508 4 36.2712 12.7262 11.2865 10.3444 9.98072 -18.0035 +7509 6 52.1161 23.0926 41.2793 27.7225 -3.87143 -59.8556 +7510 4 52.4049 23.0393 40.2964 5.44511 3.0042 51.4604 +7511 4 51.1968 22.9093 41.149 -26.7248 -2.75497 17.7375 +7512 6 39.5495 11.6692 16.6079 -1.17202 -14.5197 -14.1262 +7513 4 39.7784 10.7494 16.7482 7.99576 -7.98247 -12.1867 +7514 4 39.4663 11.9292 17.5115 -4.38422 20.0879 20.6825 +7515 6 0.676885 9.01905 7.96736 13.1741 22.7352 -22.4375 +7516 4 54.8016 8.92404 8.29683 -40.226 7.08621 2.19233 +7517 4 1.10058 8.31451 8.38908 28.7575 -30.4684 16.9583 +7518 6 42.3311 28.7401 39.4661 13.4879 80.877 11.2525 +7519 4 41.6603 28.5849 40.0851 -34.7426 -11.2721 27.5092 +7520 4 42.5519 27.921 39.1558 20.2132 -66.4303 -37.3003 +7521 6 38.7411 30.2829 16.2738 12.7671 5.32399 18.4704 +7522 4 38.9183 29.8748 17.1496 -6.87016 4.31697 -11.6029 +7523 4 39.4059 31.0046 16.2472 -14.9795 -12.5163 -3.03567 +7524 6 7.58764 18.0405 0.648325 -47.6574 -19.7672 20.3632 +7525 4 7.12731 17.6217 1.42737 12.1211 9.19751 -27.5752 +7526 4 8.47251 18.0259 0.938181 42.7013 4.4664 8.86021 +7527 6 33.7296 34.5938 24.1405 -3.484 -2.51034 -8.30179 +7528 4 33.5251 35.3309 23.5532 1.13599 -1.72579 4.26838 +7529 4 33.8994 34.9649 25.0137 6.47563 -1.63099 1.09862 +7530 6 16.0166 40.0494 39.5956 -28.3908 0.329345 -1.37751 +7531 4 16.9382 40.2323 39.4336 17.0381 0.329941 -6.23981 +7532 4 15.5262 40.0524 38.7513 12.3223 -0.591958 2.13513 +7533 6 4.49229 37.1333 21.8385 27.3085 -52.2253 -58.5501 +7534 4 4.66683 37.716 22.5264 18.8147 38.5231 40.56 +7535 4 5.37915 36.8768 21.3985 -41.7208 12.465 14.7942 +7536 6 39.2691 20.1288 31.3316 -12.2203 -9.20146 -18.9279 +7537 4 39.1503 20.9416 31.8094 1.95478 16.2675 16.373 +7538 4 38.6746 20.1785 30.5607 4.99665 9.53371 7.24081 +7539 6 28.5508 6.16368 32.0494 2.8072 -5.52183 -6.01527 +7540 4 29.3622 6.49582 32.4253 9.65206 -4.8896 7.96618 +7541 4 28.0782 6.98121 31.874 -4.3704 -0.58129 1.95425 +7542 6 9.33595 11.3298 38.1871 -32.8874 9.84086 11.8913 +7543 4 8.64445 12.0594 38.2922 21.8008 -26.7714 -10.0524 +7544 4 8.88851 10.5546 37.784 7.69784 20.5749 -6.72048 +7545 6 41.6095 10.4782 6.86111 8.23897 -6.62675 34.9169 +7546 4 41.7694 10.1037 7.78655 -4.1265 15.4661 -32.721 +7547 4 41.7821 11.4382 6.90291 -3.49967 -11.9299 -5.09907 +7548 6 3.12867 28.1157 17.6206 15.6267 -45.6796 29.9202 +7549 4 2.63816 28.6493 17.0564 -29.7899 29.6493 -43.0934 +7550 4 3.59757 28.7421 18.155 7.53462 9.15161 11.5693 +7551 6 39.3499 12.2397 19.2529 -23.7838 14.9837 13.9357 +7552 4 39.2457 13.2286 19.3464 7.91877 -27.4185 3.68816 +7553 4 38.6075 11.8387 19.7677 15.6586 5.94778 -12.3856 +7554 6 2.78491 9.11686 31.712 -26.5503 -22.4732 34.9375 +7555 4 3.2978 8.41451 32.2045 -9.27186 19.8876 -17.5091 +7556 4 3.27525 9.5282 31.0263 27.6548 6.40843 -16.0242 +7557 6 47.0993 34.3062 24.1668 40.213 25.5871 3.96938 +7558 4 47.8652 34.9011 23.9742 -8.40565 -28.0457 9.8184 +7559 4 46.4391 34.8642 23.795 -37.1496 -1.08965 -6.28687 +7560 6 41.29 35.6184 9.54316 -30.0867 29.8286 7.21591 +7561 4 40.3249 35.7138 9.72984 17.4159 -14.0538 -3.31523 +7562 4 41.5907 36.542 9.70742 6.71087 -21.892 -10.0971 +7563 6 20.4656 31.4513 3.14505 -29.4444 2.15246 21.5865 +7564 4 20.9799 31.2087 3.9226 8.79014 -0.482357 -2.15716 +7565 4 19.5517 31.5947 3.51954 23.5031 -1.57475 -20.844 +7566 6 33.2192 17.965 24.7971 19.8065 25.0952 18.1835 +7567 4 34.1598 18.0267 25.093 -16.2559 -11.4614 -7.96855 +7568 4 32.9244 18.9016 24.8301 -6.14071 -21.8705 -2.46334 +7569 6 40.1545 39.892 35.7566 -26.4952 1.03865 35.1005 +7570 4 39.554 39.7115 35.0283 3.12548 3.08468 -2.58895 +7571 4 39.5538 40.0617 36.55 23.7339 -1.54775 -30.4418 +7572 6 4.86493 34.7165 16.5037 -1.18866 4.83191 -8.79653 +7573 4 4.98021 35.6639 16.3239 -2.48039 -7.07182 -3.79473 +7574 4 5.57973 34.27 16.0245 9.17482 -2.77359 5.31354 +7575 6 19.1203 11.0308 26.5475 4.8369 12.9311 -1.38474 +7576 4 19.2948 10.8261 25.6303 -10.7878 -2.53157 -9.81197 +7577 4 19.6222 10.3806 27.0285 -0.932765 -12.0852 11.9627 +7578 6 54.013 13.9266 34.7866 19.735 -12.4153 18.0126 +7579 4 53.1377 14.0488 35.1524 -10.4928 -1.09871 -13.0068 +7580 4 53.982 14.1469 33.8595 -3.66316 10.2302 -11.2602 +7581 6 1.83695 20.649 5.20524 25.5491 14.9074 -17.0883 +7582 4 1.35705 19.8566 4.90021 2.5306 9.60758 -2.11708 +7583 4 2.48138 20.9466 4.48633 -27.5057 -15.388 16.1855 +7584 6 22.2484 0.089789 14.2543 15.3573 -11.1234 0.0573231 +7585 4 21.4821 0.622149 14.4313 -9.66168 8.29964 10.305 +7586 4 22.7606 41.8363 15.0657 -14.7435 5.42194 -5.09127 +7587 6 4.9437 7.03924 24.7311 13.2528 -2.19763 7.32506 +7588 4 4.13251 7.3412 24.2993 4.98795 -3.92941 -4.4547 +7589 4 5.31694 6.26419 24.274 -9.7854 5.58222 5.45409 +7590 6 41.4768 20.8727 34.9433 -10.8141 32.3245 17.6117 +7591 4 42.0721 20.1596 35.0936 18.2074 -21.2429 -2.25611 +7592 4 41.5511 21.3995 35.7803 -3.93981 -14.5735 -18.4651 +7593 6 28.2063 1.73787 31.7361 2.56856 -6.63991 -21.6427 +7594 4 27.5833 1.04583 32.0206 5.931 11.5306 2.70007 +7595 4 28.427 2.28487 32.4907 -6.15569 2.19681 12.1249 +7596 6 16.8959 27.3728 36.9936 3.36683 -9.46076 -21.7251 +7597 4 17.1861 28.0765 36.4018 -0.835984 6.87178 9.62195 +7598 4 17.1491 26.5677 36.4964 -8.72142 5.45523 11.8618 +7599 6 26.8172 38.095 8.33253 -7.04389 15.4319 43.7153 +7600 4 26.4231 38.1886 9.22965 13.1827 16.4204 -18.9623 +7601 4 26.752 37.1697 8.26194 2.82704 -45.8494 -18.5449 +7602 6 26.6605 33.8021 23.2109 -14.7721 -8.40788 6.86704 +7603 4 27.1437 33.2455 22.6071 1.71839 -3.83047 -13.3917 +7604 4 27.3181 34.0928 23.8234 13.6598 11.6313 12.8928 +7605 6 10.2089 27.1103 30.2249 26.5091 -20.839 -19.8889 +7606 4 10.2296 28.0525 30.305 -4.35446 23.414 7.17464 +7607 4 10.909 26.9135 29.5485 -17.3927 5.996 19.4297 +7608 6 47.8678 12.6068 5.01236 10.3402 17.2727 14.3835 +7609 4 48.2471 13.4466 5.34357 -15.5974 -13.1618 -9.91905 +7610 4 48.2827 11.9587 5.58273 0.760146 -12.24 2.37579 +7611 6 53.3401 24.5564 22.1447 -33.4845 3.13007 15.4457 +7612 4 53.2868 24.6175 23.1082 -8.50106 -5.88574 1.47389 +7613 4 54.2491 24.6404 21.954 37.9576 4.9603 -12.0283 +7614 6 29.4115 10.751 19.3682 47.3718 16.1602 -3.46693 +7615 4 29.23 9.95501 18.9095 -1.62259 -22.6341 -18.5903 +7616 4 28.6164 10.8767 19.816 -47.8248 15.8998 30.722 +7617 6 39.4772 14.9486 19.552 50.4126 11.9025 42.2912 +7618 4 40.3976 15.2789 19.8627 -47.7598 -21.1435 -8.50237 +7619 4 39.4723 15.2512 18.6704 -12.4406 15.8155 -35.6919 +7620 6 32.8813 15.9868 22.8125 3.47488 17.0872 -31.9433 +7621 4 33.0166 16.4922 23.6113 -1.39335 7.20309 14.6349 +7622 4 32.7144 15.0846 23.0256 -4.37432 -22.045 19.0968 +7623 6 30.558 1.96704 21.5074 2.70654 -4.91402 -0.473851 +7624 4 30.6739 2.00523 22.4671 5.88049 3.20632 -1.97238 +7625 4 31.3728 1.59666 21.1136 -11.8747 6.17773 7.16567 +7626 6 0.976021 12.0022 3.31788 -2.33791 2.9975 -11.3542 +7627 4 1.23381 12.945 3.27167 -8.13702 -10.1344 5.41434 +7628 4 1.05317 11.6593 4.21576 7.83216 6.74936 8.77967 +7629 6 32.1417 30.4028 20.7928 -10.9162 7.90477 -12.8705 +7630 4 32.9583 30.6218 20.3315 4.32484 3.35409 -0.814586 +7631 4 31.4267 30.7883 20.2371 10.7836 -11.8724 10.7529 +7632 6 5.37233 35.5196 8.9984 1.65786 -0.655334 17.0686 +7633 4 5.15633 35.7733 8.10502 -8.52999 -6.98357 -10.434 +7634 4 4.86772 34.7263 9.2434 -1.9757 2.02155 -6.9424 +7635 6 49.9125 13.0387 32.1973 27.4626 15.6741 -16.8517 +7636 4 50.6053 12.9182 31.4733 -26.2683 -0.306922 26.3637 +7637 4 49.2504 12.3613 32.0764 -3.75185 -11.6573 -0.304044 +7638 6 4.31386 24.093 1.57868 7.45772 -24.8618 -14.5348 +7639 4 3.64218 24.7342 1.7864 -13.9986 8.43803 -2.25361 +7640 4 4.01488 23.4668 0.872394 2.3276 24.3041 16.4513 +7641 6 44.1644 38.1215 12.3455 -22.0907 -25.3739 20.9172 +7642 4 43.5152 37.5597 12.8481 16.1408 4.83783 -17.5332 +7643 4 43.8688 38.9961 12.5721 5.21907 21.319 -3.3764 +7644 6 44.6817 17.3326 22.8013 48.0619 -4.56356 -9.07637 +7645 4 45.2902 18.0584 23.1498 -22.5072 -22.7727 -5.21409 +7646 4 45.2932 16.6008 22.4593 -20.015 30.0459 19.1644 +7647 6 20.3678 11.7042 19.6638 18.1083 -41.9451 -24.672 +7648 4 19.8947 12.3606 20.1264 -14.0753 36.8205 14.9866 +7649 4 20.5011 12.0109 18.7433 -0.799123 0.72776 10.7716 +7650 6 4.45477 15.3976 36.1886 1.65809 1.26145 11.9226 +7651 4 5.09661 14.6681 36.098 -4.75494 5.61497 -10.92 +7652 4 3.56051 15.0123 36.2095 4.93474 0.57137 -3.51241 +7653 6 44.8032 39.5214 30.1736 10.2403 3.65831 -28.7798 +7654 4 44.6649 39.352 29.2044 0.893291 -3.4354 28.9244 +7655 4 44.1834 39.0261 30.7164 -9.9549 -0.503639 -4.51595 +7656 6 30.0776 3.52093 11.3186 -8.111 -9.63673 -5.93937 +7657 4 30.5797 4.33725 11.0789 -10.9699 -19.7375 -4.73534 +7658 4 29.9808 2.85663 10.5812 14.022 21.906 10.2093 +7659 6 25.6241 24.8658 16.1333 6.68449 -9.57605 -29.1286 +7660 4 26.5694 24.8046 15.8818 -8.72523 1.1772 17.1704 +7661 4 25.5267 25.1318 17.0381 12.8553 5.85519 26.3055 +7662 6 36.8177 29.8487 20.6561 -37.5479 -3.0004 33.0202 +7663 4 35.926 30.1959 20.4157 18.2985 -1.907 -0.407745 +7664 4 36.6716 29.3784 21.5423 12.7247 15.2026 -39.3319 +7665 6 52.2186 17.0658 38.3042 -7.89215 -38.4825 28.5148 +7666 4 51.4916 16.4675 38.6484 24.7832 21.5941 -14.95 +7667 4 51.8247 17.6139 37.6469 -10.8917 8.73986 -12.7264 +7668 6 3.82879 23.6249 29.8747 0.0111461 24.9347 -0.194649 +7669 4 4.57266 23.2964 29.3507 7.82142 7.55197 5.89536 +7670 4 4.12107 24.4472 30.3626 -2.93665 -31.334 -6.69289 +7671 6 6.37221 19.8955 41.0814 -10.7405 10.6187 0.232117 +7672 4 6.67124 19.2607 41.7286 9.67887 -12.4754 3.81392 +7673 4 6.49825 20.7419 41.4991 -1.14685 10.1205 10.9238 +7674 6 28.9128 38.9237 35.3305 22.4394 21.6131 25.3888 +7675 4 28.4594 38.2476 34.8641 -13.9867 -26.2755 -20.0992 +7676 4 29.711 38.4973 35.7105 -10.7836 3.83713 -8.57645 +7677 6 1.06675 30.3059 34.4729 25.4378 -4.31804 35.0042 +7678 4 0.780778 29.8064 33.7399 -5.76855 -22.7951 -38.2413 +7679 4 0.490797 31.0506 34.5199 -18.1513 16.5028 -0.872558 +7680 6 26.4359 22.0299 20.4363 32.8101 13.5123 0.44111 +7681 4 27.364 22.3315 20.3938 -13.8894 -16.1779 0.0777322 +7682 4 25.9647 22.8561 20.3336 -19.4369 -2.2953 -2.32927 +7683 6 3.94837 18.6341 22.6823 32.7056 -17.0211 23.8668 +7684 4 4.7768 18.6814 23.2391 -24.3494 -8.73456 -16.7413 +7685 4 3.72444 19.5457 22.6416 -13.4357 33.3979 -9.86072 +7686 6 6.89585 39.3162 26.9832 -46.5714 7.68979 7.72716 +7687 4 6.93923 40.0377 27.612 28.7888 3.33438 12.9127 +7688 4 5.92214 39.2413 27.0287 16.4173 -5.75108 -11.0421 +7689 6 43.9872 41.7521 26.5322 17.8857 -12.0416 -16.5154 +7690 4 43.9509 0.2718 27.3768 -8.40653 9.77536 19.5266 +7691 4 43.1315 41.809 26.1188 -22.0408 9.50446 -3.00799 +7692 6 31.7113 29.5746 16.987 -20.6637 1.93471 5.13032 +7693 4 31.02 28.863 17.0135 12.5534 15.6398 -7.64726 +7694 4 31.2508 30.4156 17.2234 10.2038 -24.3383 2.42367 +7695 6 46.2561 10.9612 15.5385 0.577538 -38.7584 22.3134 +7696 4 45.3251 10.7213 15.4484 -5.02058 7.03855 -0.171485 +7697 4 46.6569 10.0824 15.7727 -2.20865 28.2857 -11.3723 +7698 6 36.5827 15.0435 25.8168 31.2067 4.61936 9.12499 +7699 4 37.3875 15.5118 26.1911 -33.209 -18.98 -14.6655 +7700 4 36.1295 14.6889 26.5897 -4.0863 -6.05063 3.58839 +7701 6 47.2722 22.6647 6.13576 -8.17133 27.0247 -35.749 +7702 4 46.6204 23.3224 5.77393 14.8224 -22.4366 13.8178 +7703 4 46.9842 22.4705 7.01441 -4.98592 -2.25738 16.061 +7704 6 27.5378 39.6651 17.8024 -2.94112 10.9701 -10.3343 +7705 4 26.5953 39.7232 17.618 -8.53785 1.10642 -8.0722 +7706 4 27.5664 39.1005 18.5557 5.38052 -12.9364 18.2146 +7707 6 14.0357 27.9675 36.8848 11.7171 -39.9071 2.25396 +7708 4 13.4367 27.1833 36.8225 11.7441 28.4062 -4.63591 +7709 4 14.9372 27.5486 36.8957 -17.1932 18.8386 1.76957 +7710 6 33.7684 13.0304 13.8649 26.1794 -24.2655 -33.187 +7711 4 34.6252 12.938 13.363 -28.3858 22.7045 20.1179 +7712 4 33.4338 12.1329 13.7478 -6.61414 4.24237 14.4002 +7713 6 3.3826 17.477 1.97134 -12.4208 -32.1468 -36.6933 +7714 4 2.99872 16.7111 1.40376 19.9781 39.313 29.0042 +7715 4 3.44044 18.2025 1.33186 0.336883 0.1642 8.16047 +7716 6 27.5407 2.76347 36.4361 37.1152 10.6125 -5.75272 +7717 4 28.1274 2.95293 35.6781 -8.18971 -2.06925 12.0999 +7718 4 26.7696 2.41682 36.0063 -15.232 -6.73967 7.66134 +7719 6 21.3092 1.20818 18.7198 27.6808 -56.7894 17.4302 +7720 4 20.9088 2.03925 18.6129 -17.8717 42.912 1.2548 +7721 4 21.1846 0.863131 19.6413 -10.5106 12.8119 -18.3621 +7722 6 11.8887 16.6751 29.3062 -13.3787 -14.7829 9.57092 +7723 4 10.9992 16.5416 28.8882 19.0949 3.10928 11.6713 +7724 4 11.8781 16.1991 30.1864 -3.15773 18.3703 -25.9576 +7725 6 15.9606 29.4505 29.6321 19.1231 40.0535 19.8704 +7726 4 16.8787 29.2659 29.409 -1.79459 -0.812108 -5.15406 +7727 4 16.0576 30.3074 30.1528 -10.887 -31.0851 -11.0284 +7728 6 42.9296 7.03459 4.51333 33.3286 4.63812 8.33203 +7729 4 43.4321 7.52085 3.82302 -14.3213 -8.56549 9.51251 +7730 4 43.6462 6.74019 5.1384 -26.8219 -5.28882 -15.1101 +7731 6 46.4281 26.3352 18.5118 -29.5226 20.9834 -10.3716 +7732 4 46.6343 27.1839 18.9751 -0.829481 -30.2492 -9.82569 +7733 4 45.6684 26.5824 17.9287 20.9241 -8.5113 7.46212 +7734 6 26.8394 31.9326 30.1088 25.5924 -16.6135 -32.4851 +7735 4 27.2107 31.0232 29.8435 -20.3392 35.4128 12.4615 +7736 4 26.6802 32.4017 29.2373 1.48159 -21.8349 29.7067 +7737 6 19.4878 37.6142 31.2562 -14.4543 3.58951 24.8148 +7738 4 19.156 36.8698 30.7235 -3.28844 3.66685 11.8368 +7739 4 19.1019 37.6358 32.1884 8.87174 -10.6544 -29.6345 +7740 6 52.3726 32.7139 12.8078 14.0751 37.5782 -32.6023 +7741 4 51.9367 33.0602 12.0031 -5.44932 -19.1877 9.81768 +7742 4 53.2329 33.1776 12.7347 -13.6236 -17.9256 14.0183 +7743 6 6.74161 9.28353 24.0307 -13.1667 -36.0519 9.75632 +7744 4 6.38029 9.61276 23.1997 0.718458 -3.76261 -6.90188 +7745 4 6.16941 8.51095 24.2946 11.6474 19.2019 -8.42102 +7746 6 39.7455 39.5612 25.4988 -8.346 1.54154 -0.59194 +7747 4 39.7035 38.6168 25.2826 0.975023 6.38379 0.651723 +7748 4 38.8484 39.7767 25.8082 2.0142 -6.85885 -0.770105 +7749 6 24.0762 14.0053 21.1456 13.3165 -18.5501 -35.6859 +7750 4 23.5798 13.5675 21.8237 -9.9014 -1.44375 19.5869 +7751 4 24.3047 13.2647 20.5221 -3.72657 29.1491 15.9401 +7752 6 5.19759 41.7876 24.8616 10.5329 -30.3401 13.9713 +7753 4 5.96107 0.070496 25.4117 5.01198 -1.48177 -8.04364 +7754 4 4.80364 0.70791 24.6471 -6.87058 19.426 -10.6286 +7755 6 42.3635 20.8692 21.2747 32.7502 -34.6644 -10.1673 +7756 4 42.4242 20.4785 22.1458 -3.583 2.66194 10.2144 +7757 4 41.7418 21.5604 21.318 -29.6652 28.4695 2.24145 +7758 6 48.2477 15.3659 33.5923 1.80889 -1.28345 12.5443 +7759 4 48.6164 14.6993 32.9992 0.330488 0.612282 -4.05403 +7760 4 47.6342 15.9182 33.1009 -4.13716 0.340872 -13.8372 +7761 6 46.021 38.2915 16.5867 23.3569 13.4435 24.034 +7762 4 46.6714 37.7063 17.0526 -15.1447 15.3639 -15.4724 +7763 4 46.2171 39.2064 16.9307 -10.1858 -20.2136 -16.2853 +7764 6 4.64649 28.484 21.3661 -49.4423 -36.8464 -34.122 +7765 4 5.0061 28.857 22.1388 17.5694 9.2675 37.6073 +7766 4 4.11403 27.6656 21.6036 24.8595 24.6655 -3.1651 +7767 6 20.5601 15.1658 18.389 17.6685 -18.4833 12.4376 +7768 4 20.0269 15.9148 18.1339 -10.4277 9.01273 0.992097 +7769 4 20.1375 14.696 19.1318 -1.87864 11.9594 -2.12399 +7770 6 16.2536 13.648 17.4664 -31.6255 -3.12789 -19.3987 +7771 4 16.1444 14.6075 17.6118 2.65347 -13.1818 -8.15029 +7772 4 15.6032 13.3943 16.7283 22.0135 11.6863 31.5082 +7773 6 52.4969 30.9511 18.1582 10.5176 -22.8935 27.2955 +7774 4 52.1187 31.5845 17.5724 -17.5669 13.4893 -21.7562 +7775 4 51.7599 30.5669 18.6706 14.518 10.6779 -8.97027 +7776 6 24.417 1.73185 15.7818 -6.46311 -4.24469 33.4298 +7777 4 24.2563 1.19981 16.5985 3.98325 2.24538 -18.7421 +7778 4 24.1038 2.61269 16.0335 4.13298 0.832539 -9.96215 +7779 6 23.8696 5.09384 31.0808 18.8621 -40.8234 -26.8653 +7780 4 23.8491 5.89936 31.5593 0.144588 30.2314 14.3891 +7781 4 24.8063 4.82715 30.9043 -17.3015 12.7186 6.18451 +7782 6 29.664 30.9246 0.393748 19.8337 -4.81556 23.0674 +7783 4 30.503 30.586 0.018652 -21.3617 6.75777 -1.54054 +7784 4 29.144 31.3327 41.6109 -5.17979 -0.628515 -14.2195 +7785 6 32.8496 37.8945 22.5158 10.0753 4.77658 10.1953 +7786 4 33.692 38.178 22.1563 2.67507 -3.41774 -7.7275 +7787 4 32.953 38.1222 23.4459 -10.6691 2.21895 5.00606 +7788 6 16.4801 17.3789 33.7607 -9.23434 -4.14589 -23.771 +7789 4 15.9446 17.8653 33.093 7.5539 3.01496 23.5583 +7790 4 17.136 16.9338 33.2029 1.0053 3.7812 3.66748 +7791 6 9.22576 13.3955 27.544 21.8484 -6.91303 -4.28818 +7792 4 8.36976 13.4851 27.1157 -15.2219 0.444174 10.4645 +7793 4 9.14931 12.9772 28.4181 -9.36318 7.36421 3.71477 +7794 6 43.4776 7.7356 17.2334 -9.59035 3.82748 19.1182 +7795 4 43.4092 7.74545 18.2218 0.501649 1.62452 -33.0026 +7796 4 44.4173 7.85634 17.0579 0.99974 -1.57098 -4.99047 +7797 6 22.314 24.3423 23.1668 -12.6246 5.51695 -1.93377 +7798 4 22.7955 23.5193 23.2443 6.83464 -10.1031 3.26418 +7799 4 21.5276 24.1384 22.6266 3.35813 5.31764 3.82921 +7800 6 26.0086 32.9187 32.7195 -0.756619 6.65713 -1.20686 +7801 4 26.2515 32.7095 31.8047 -0.82286 -4.52018 -0.557583 +7802 4 25.2078 32.4163 32.9092 -2.81033 -0.378904 -0.617388 +7803 6 16.9305 19.0463 7.44765 14.0068 18.7364 -6.96389 +7804 4 16.3855 19.2981 8.21028 -2.47769 1.30563 -6.88861 +7805 4 17.0815 19.8512 6.87677 -9.59141 -23.4241 18.196 +7806 6 48.1118 14.458 27.5672 -1.70385 5.14823 10.3583 +7807 4 48.0423 15.1786 26.9235 1.90686 -4.78611 -1.19899 +7808 4 48.0875 14.8765 28.4507 4.89589 -0.740891 -11.823 +7809 6 52.3863 41.7399 11.1185 2.41988 14.2085 23.7397 +7810 4 52.3863 0.193993 10.2459 -4.45976 10.8931 -22.0542 +7811 4 52.6887 0.557857 11.7005 -5.56281 -10.4239 -7.84704 +7812 6 36.3311 6.93589 12.7094 -2.38398 9.53491 -1.97617 +7813 4 36.3789 7.90344 12.827 -2.48918 -10.7733 3.15906 +7814 4 37.2588 6.6822 12.6726 5.22435 -7.00461 -0.877062 +7815 6 8.24215 20.3216 16.6719 4.98767 -5.10439 -5.65687 +7816 4 8.08588 19.3952 16.4038 -4.3079 5.82994 10.8424 +7817 4 9.2046 20.4438 16.7199 -1.30961 -3.63404 -4.19262 +7818 6 28.7954 40.3113 12.828 -13.6179 6.23593 21.4452 +7819 4 29.5192 40.3706 12.2287 20.8327 -7.3113 -16.8089 +7820 4 28.5554 39.3777 12.9053 -3.26344 4.60902 -2.65931 +7821 6 18.1473 11.8343 16.9395 -0.80483 -16.2761 12.6256 +7822 4 17.6848 12.6388 17.2294 4.62203 -2.59462 -3.9508 +7823 4 19.0947 11.9922 16.9221 7.13726 16.095 1.27241 +7824 6 30.8869 17.4142 21.504 -52.7305 12.2285 -31.3088 +7825 4 30.1482 16.8222 21.1884 27.1221 10.2955 22.0665 +7826 4 31.6253 16.8731 21.7262 19.9221 -18.6281 13.9623 +7827 6 34.8012 19.4194 37.9626 16.1869 22.0253 -15.6613 +7828 4 34.8979 20.1386 37.2822 -2.41662 -18.1877 20.3873 +7829 4 34.2105 18.7604 37.6043 -6.15487 -8.04615 -10.7113 +7830 6 35.8208 16.8923 29.2032 22.3367 20.7443 33.8648 +7831 4 36.613 16.5252 29.6466 -9.20578 0.119567 -6.22754 +7832 4 35.5382 16.2441 28.5922 -11.4717 -30.451 -21.7041 +7833 6 3.04279 32.2854 6.33929 -26.9238 12.3825 -4.69033 +7834 4 2.12647 32.146 6.0594 1.42689 6.59766 6.64942 +7835 4 3.42261 31.4611 6.08203 25.9982 -20.506 -0.598367 +7836 6 26.7966 41.6596 10.1464 32.6739 -10.8326 9.81865 +7837 4 27.6955 41.4226 9.79016 -25.5431 4.71255 4.81996 +7838 4 26.9918 0.01593 11.0584 -5.4334 2.64263 -3.14356 +7839 6 52.266 24.562 24.8685 -9.42886 0.421982 -6.72882 +7840 4 51.3046 24.7615 24.9057 17.7877 -5.82089 5.23086 +7841 4 52.6568 24.8699 25.6923 -4.67896 5.24225 9.60646 +7842 6 22.6938 22.6511 33.5751 -3.71591 7.58927 38.5179 +7843 4 23.2073 23.1628 34.2375 -1.81825 -3.74423 -24.5931 +7844 4 21.9227 22.4274 34.1227 -1.3969 -6.37714 -14.1968 +7845 6 10.6508 14.2453 33.0462 38.3111 -19.1724 1.31243 +7846 4 10.5904 14.9583 32.4175 -11.7628 10.624 -9.61146 +7847 4 9.79743 14.0525 33.3881 -28.4056 0.15536 2.16046 +7848 6 21.8963 10.8464 11.5207 26.0054 2.65771 10.2946 +7849 4 22.8204 10.615 11.7238 1.04479 5.32162 -7.74354 +7850 4 21.5123 10.8483 12.397 -14.7134 -4.5627 10.8449 +7851 6 38.3602 6.02493 25.8481 -1.65407 -6.16467 0.326828 +7852 4 38.011 6.16356 26.7557 4.19059 11.4538 -13.8011 +7853 4 38.4332 6.8537 25.3449 -2.0709 2.94932 12.5244 +7854 6 30.9335 26.6426 38.5759 12.2579 -6.52521 -50.146 +7855 4 30.9725 26.4832 39.4983 -1.12433 -12.3748 34.5417 +7856 4 31.1634 25.7976 38.1184 -10.2303 12.0451 18.6771 +7857 6 30.1758 14.6176 35.4883 -28.0954 45.5198 -22.6945 +7858 4 30.377 15.4621 34.9933 16.3957 -28.3235 8.82257 +7859 4 29.2055 14.6893 35.4544 11.1506 -16.8188 10.9927 +7860 6 12.5393 37.2199 16.9523 -39.8589 -5.36999 -7.27655 +7861 4 12.8749 37.9509 17.4338 22.3846 22.4284 20.6781 +7862 4 13.1653 36.5135 16.9845 23.2041 -13.3789 -0.375674 +7863 6 27.4265 21.5607 37.7225 20.8747 -12.9562 -0.181201 +7864 4 26.9326 21.725 36.9211 -12.0211 3.79264 -7.84561 +7865 4 27.0206 21.994 38.4656 -12.5008 8.35973 2.85409 +7866 6 29.6119 18.3909 12.6766 5.02953 -16.5769 27.1188 +7867 4 29.5217 18.1084 13.6179 -1.01954 6.11509 -19.9302 +7868 4 28.7057 18.4542 12.3734 -9.03627 4.70036 -1.08008 +7869 6 2.35849 15.6559 0.172343 -13.1317 26.5324 40.4931 +7870 4 1.57628 15.538 41.5798 -33.9312 2.46749 -10.4392 +7871 4 2.94928 15.1153 41.6306 46.9044 -35.3027 -23.6199 +7872 6 17.8239 25.728 4.21905 -37.6117 -8.49993 -31.7596 +7873 4 16.8718 25.6243 3.8952 33.4499 1.9374 22.526 +7874 4 18.2969 25.7387 3.3671 7.88894 5.9968 18.5236 +7875 6 41.8048 11.1855 20.2736 -2.74436 -4.31591 -6.39865 +7876 4 42.499 11.3266 19.6063 -2.31748 -7.213 6.47037 +7877 4 40.9812 11.3277 19.7997 -4.16553 7.78699 0.129723 +7878 6 38.0436 18.3822 24.0291 -8.03771 -8.75406 0.916934 +7879 4 38.3881 19.1147 24.5363 7.93091 8.32946 7.65245 +7880 4 37.8775 18.7197 23.1534 1.15748 3.59885 -9.88254 +7881 6 4.13949 13.9245 33.751 32.8429 -54.5446 -5.73928 +7882 4 3.27676 13.674 34.0388 -19.3763 3.63281 4.9893 +7883 4 4.61955 13.0097 33.6871 -20.752 50.0513 -2.76975 +7884 6 19.1955 19.1942 26.4999 -2.68794 -13.6734 16.0889 +7885 4 19.5301 20.0447 26.2113 2.49975 9.05121 -5.4902 +7886 4 18.8802 18.7176 25.7363 0.91839 -0.338605 -10.966 +7887 6 22.4654 26.212 25.3377 -43.9819 -31.3945 15.8492 +7888 4 22.341 25.462 24.7348 6.987 2.92742 -4.90062 +7889 4 23.2684 26.6111 25.1223 47.0594 15.091 -19.0516 +7890 6 48.8212 32.07 32.5598 -32.6217 13.0764 9.49579 +7891 4 48.8519 31.1339 32.3903 9.77015 -16.5586 -2.94571 +7892 4 49.6142 32.4858 32.2593 19.8009 3.1546 -7.06015 +7893 6 25.2092 18.0177 27.0119 4.84672 -18.7822 -3.15467 +7894 4 24.5216 17.4674 27.4199 2.41306 12.0417 3.55819 +7895 4 25.6695 17.4202 26.3966 -2.25094 9.61905 1.21472 +7896 6 1.75029 41.5558 24.9373 10.8929 -9.66126 -16.5331 +7897 4 1.94143 40.8029 24.3062 -11.1729 27.8661 22.017 +7898 4 1.33214 0.330238 24.3814 7.15774 -16.2959 10.6574 +7899 6 18.6827 11.7655 10.8523 -12.8723 -21.6642 16.1997 +7900 4 19.5636 11.9042 10.4948 -5.12175 -0.337419 -4.96303 +7901 4 18.6779 10.8452 11.2231 -2.76434 23.9208 -10.2934 +7902 6 45.6216 16.5622 4.85345 35.2391 7.72621 -8.96994 +7903 4 46.5826 16.2921 4.84248 -29.2944 1.01327 2.32041 +7904 4 45.6571 17.5026 4.56372 -8.00263 -16.2723 6.75488 +7905 6 40.6693 36.3938 24.0175 15.8353 8.34465 -33.37 +7906 4 40.8833 36.7626 23.1096 -14.2319 -6.57786 31.0793 +7907 4 40.765 35.4388 23.9669 -2.25062 -4.28397 3.06966 +7908 6 32.2103 36.323 4.961 11.3673 -15.0032 -27.5021 +7909 4 31.6022 36.0041 4.27996 -13.8963 14.3234 5.17466 +7910 4 32.9864 35.7931 4.73143 4.05858 7.46319 17.1387 +7911 6 1.60869 14.6755 10.8061 -10.0389 6.06769 39.8197 +7912 4 2.33356 15.3221 10.9109 -7.21973 -7.23845 -0.707439 +7913 4 1.19104 14.6475 11.7231 10.7485 2.93157 -30.114 +7914 6 35.0001 14.2727 28.079 63.2852 10.3217 34.449 +7915 4 34.8812 14.1453 29.0533 -4.19424 -2.10072 -23.3494 +7916 4 34.1798 14.2655 27.6589 -51.5469 -5.32036 -14.2309 +7917 6 54.7125 6.11605 21.8555 -14.0361 -8.25377 2.86163 +7918 4 53.7845 6.02557 22.1597 12.8111 1.82594 -4.22103 +7919 4 0.03027 6.89073 22.319 4.64766 10.0402 5.34703 +7920 6 31.7713 16.925 27.3783 -6.86907 -7.88471 17.2493 +7921 4 30.8352 17.1376 27.29 -7.38275 1.84485 -8.02972 +7922 4 32.1916 17.1776 26.567 8.49209 11.7792 -21.4891 +7923 6 14.465 28.0197 11.093 -4.59026 -39.5121 13.6529 +7924 4 14.1257 28.8224 11.4501 -8.46011 24.0779 0.0563038 +7925 4 14.7692 28.1802 10.1981 4.52198 5.50754 -5.24146 +7926 6 35.6475 19.4845 18.3155 9.57103 -1.809 -3.39748 +7927 4 36.1727 19.3545 19.1113 -4.74674 6.51425 2.74698 +7928 4 35.0476 18.7267 18.3208 -0.78661 10.9943 -3.1182 +7929 6 0.909574 12.7326 15.4512 -4.00403 -44.3255 -0.361194 +7930 4 0.713888 11.7498 15.2844 2.79491 38.2978 9.54583 +7931 4 1.42535 12.7402 16.2831 -6.10996 -1.10113 -5.97882 +7932 6 52.7151 14.8297 20.9852 -8.18072 -78.4028 12.8764 +7933 4 52.2089 13.9625 20.7908 19.9141 35.1606 18.4317 +7934 4 52.3599 15.4219 20.3591 -8.09633 28.1752 -16.3986 +7935 6 7.5074 6.79303 13.6094 20.1749 -33.1825 -2.20484 +7936 4 7.51894 7.72815 13.8132 13.5555 7.5777 -3.02343 +7937 4 8.44355 6.42469 13.5879 -32.5694 21.0012 0.325521 +7938 6 12.8707 29.146 30.9458 -23.5578 15.3335 -40.981 +7939 4 12.9428 28.445 30.3111 -4.06483 -0.044806 -18.3112 +7940 4 13.2276 28.7127 31.6654 25.7046 -17.9249 62.7325 +7941 6 8.91318 29.991 35.6703 -0.0610651 3.14803 31.5119 +7942 4 8.887 30.0597 36.6571 13.1627 -14.4278 -23.4692 +7943 4 8.81345 30.9051 35.4106 0.983205 7.41015 -17.1111 +7944 6 29.2436 7.20633 5.57892 -54.0378 33.243 -15.4453 +7945 4 29.9077 6.6209 5.82325 37.3203 -38.0996 12.3519 +7946 4 28.4255 6.92245 6.05186 24.5111 10.6259 -6.90283 +7947 6 25.8948 9.2579 3.86177 -16.7921 -19.1399 -16.9328 +7948 4 26.6486 8.78935 3.46547 3.6066 2.83982 9.7025 +7949 4 25.146 8.75694 3.47524 9.6908 8.1243 10.3781 +7950 6 46.1591 19.5353 23.8511 81.1089 -3.44953 5.31324 +7951 4 47.0572 19.4192 24.3423 -46.5837 0.334518 -9.80273 +7952 4 46.5432 19.8542 23.0066 -21.4105 0.836057 1.37554 +7953 6 18.5926 35.3225 28.784 52.2521 -24.0621 1.05868 +7954 4 18.6271 36.1437 28.292 -9.91963 10.3291 -8.20284 +7955 4 19.5499 34.9756 28.7398 -42.866 14.0686 4.10052 +7956 6 27.9863 22.6413 32.202 21.6529 -11.7193 -18.2399 +7957 4 28.0891 22.9783 31.3009 1.03266 3.02954 6.56078 +7958 4 27.1414 22.9613 32.5068 -4.28354 -0.549074 4.96673 +7959 6 25.9903 18.4326 22.6797 -22.9747 -15.6034 11.3844 +7960 4 26.7869 18.8273 22.3692 24.9379 13.7229 -5.91644 +7961 4 25.7208 18.921 23.4832 11.724 -6.94511 -8.75168 +7962 6 31.1697 23.092 29.1693 -11.9745 -15.1316 21.2053 +7963 4 31.2077 22.141 28.9533 -3.34012 7.58841 -3.35467 +7964 4 31.7416 23.575 28.5808 9.8436 3.86516 -11.5721 +7965 6 36.6303 4.93142 0.48008 48.3 12.3871 -22.3067 +7966 4 36.6637 5.82298 0.895967 -3.77214 -15.5899 -6.86281 +7967 4 37.4556 4.91994 41.7793 -42.6939 0.501904 23.801 +7968 6 36.4828 20.995 10.0445 1.4409 16.9025 7.88029 +7969 4 36.442 20.1354 9.60774 -3.67605 2.90774 1.0232 +7970 4 35.8889 20.9899 10.8082 0.675338 -5.55749 -3.21659 +7971 6 50.6068 25.1826 18.3885 -34.0155 8.99756 4.28297 +7972 4 49.9165 24.7513 17.8483 3.12051 4.84127 10.9758 +7973 4 51.4426 24.9479 18.0312 23.0155 -7.64449 -5.94589 +7974 6 50.1857 39.6546 12.4249 -35.8487 -4.75972 18.1961 +7975 4 49.7435 38.8097 12.6589 9.38526 12.3917 -5.89531 +7976 4 51.0761 39.4561 12.2056 25.3285 -5.23538 -8.69122 +7977 6 30.5392 12.4112 4.81308 -24.6918 -8.37115 23.8709 +7978 4 30.0105 11.5821 4.90198 12.5687 16.0288 7.14 +7979 4 30.9611 12.2897 3.99028 20.9425 -4.88336 -30.4106 +7980 6 28.9507 15.4785 21.8764 2.88494 -37.77 16.9414 +7981 4 29.2026 14.5932 22.3105 -13.0637 39.016 -13.1967 +7982 4 28.2142 15.8194 22.4189 7.40001 -5.36107 -10.8423 +7983 6 14.0621 9.56364 16.9937 6.86557 -12.9325 3.68967 +7984 4 14.7638 8.91135 17.1437 -0.397896 3.39204 -3.97785 +7985 4 14.5001 10.412 17.0773 -1.84745 7.98018 -3.95086 +7986 6 4.48418 30.1793 11.8502 16.4679 -16.8356 33.0547 +7987 4 4.88144 29.8061 12.6848 -7.18701 8.62616 -23.9784 +7988 4 3.54784 30.2411 12.0492 -7.30801 4.11375 -9.31782 +7989 6 40.8925 8.06286 23.6531 -5.33465 -0.617655 -7.49645 +7990 4 40.8929 8.28602 22.6923 5.67883 -10.477 13.1878 +7991 4 40.7177 7.10184 23.7416 4.86142 9.55736 -10.8624 +7992 6 53.7474 35.0502 16.7091 9.64852 13.8526 -34.5004 +7993 4 53.4511 35.8404 17.1588 -1.68768 2.98716 11.3576 +7994 4 54.0332 35.3898 15.821 -5.01984 -16.258 24.672 +7995 6 53.7089 10.1864 20.3635 2.29909 -3.91508 11.8946 +7996 4 53.865 9.95358 19.435 -6.30341 10.2468 0.803923 +7997 4 53.074 10.9174 20.4153 4.1525 1.61451 -13.3956 +7998 6 4.58325 27.0727 7.79253 38.2121 26.3993 -10.0836 +7999 4 5.27724 26.393 7.80253 -10.2172 -9.80276 1.23658 +8000 4 3.71677 26.7514 7.92113 -24.69 -25.9094 6.50141 +8001 6 50.5074 22.5408 22.1421 -8.69376 -16.3879 19.9073 +8002 4 50.2488 23.2402 22.7623 5.11604 2.17524 -13.9015 +8003 4 50.7961 22.8564 21.2903 3.5618 14.8025 -7.32432 +8004 6 7.04732 27.2027 21.6256 -40.8926 -21.8944 23.9514 +8005 4 6.7035 26.7027 22.422 28.3929 12.8045 -18.4773 +8006 4 6.19014 27.4064 21.2095 22.0893 5.82121 -6.88916 +8007 6 23.8331 35.0488 16.5891 16.32 14.4309 46.4508 +8008 4 24.6955 34.7392 16.9507 -15.4311 10.68 -10.0146 +8009 4 23.6772 34.608 15.7848 -0.180345 -20.5093 -35.2233 +8010 6 5.99568 23.9111 3.91414 -16.1284 -13.3557 2.33299 +8011 4 5.47632 24.0272 3.08057 3.14343 -7.41418 20.837 +8012 4 5.41258 23.5631 4.6401 5.53308 9.77645 -18.8553 +8013 6 38.7285 25.0725 19.1284 6.5843 12.292 11.4002 +8014 4 38.8305 24.3279 18.5317 -0.433768 -14.0645 -4.65001 +8015 4 38.9527 24.8378 20.0476 4.74577 -1.1864 -10.184 +8016 6 12.9754 18.2903 10.6176 0.588158 -4.74371 -11.7219 +8017 4 12.1189 18.2831 10.1754 -4.50324 1.27903 -1.36841 +8018 4 12.8026 18.5801 11.5112 2.24696 5.46905 14.7352 +8019 6 38.0467 41.2366 21.1082 -14.4892 -16.6352 -5.66336 +8020 4 37.1721 40.8226 21.1941 10.2151 -2.13153 3.70269 +8021 4 37.8745 0.133442 20.6393 0.730193 23.6843 -6.95691 +8022 6 6.9767 22.8602 17.8447 -15.6268 -18.8158 0.81989 +8023 4 7.5707 23.5707 17.6602 21.732 18.7089 -7.75629 +8024 4 7.31556 22.0497 17.428 2.05587 4.83625 4.35773 +8025 6 24.1095 19.3932 12.3316 12.1602 -2.11517 -13.1018 +8026 4 23.8745 19.734 13.1953 2.64822 12.0925 0.881714 +8027 4 23.8476 18.4865 12.3899 -10.6841 -23.2361 -5.46211 +8028 6 44.2232 28.4408 4.82746 -1.7669 2.66578 -25.5607 +8029 4 44.2803 28.1144 3.91045 1.22274 -3.80694 10.7546 +8030 4 44.1446 29.3994 4.68927 4.81937 -0.158515 8.55 +8031 6 23.3113 8.29915 21.4219 -9.51684 27.1403 7.66167 +8032 4 22.936 9.22921 21.4746 15.7805 -27.4461 5.90598 +8033 4 23.1012 8.0569 20.5135 3.89809 -6.65443 -0.402871 +8034 6 14.3464 2.18773 18.5362 -23.516 16.4481 4.67993 +8035 4 14.2678 1.24418 18.6898 10.1474 -10.2606 4.48578 +8036 4 15.2445 2.40605 18.3047 18.9771 -8.71598 -6.68368 +8037 6 28.0424 31.9381 34.1184 1.44373 -10.4149 10.0158 +8038 4 28.467 32.321 34.8914 3.92062 5.65333 3.09761 +8039 4 27.2701 32.5111 33.9835 5.51879 -6.95928 -12.9635 +8040 6 53.345 24.6925 18.2818 -10.4918 -25.9433 -31.7967 +8041 4 53.4866 24.6975 17.3285 -0.882305 -10.6531 -2.1422 +8042 4 53.7306 25.5021 18.5264 15.118 39.739 24.3772 +8043 6 36.8049 28.4285 22.9464 16.1639 5.31016 -1.79263 +8044 4 36.683 28.9472 23.7552 -13.3671 -7.69746 -0.238436 +8045 4 36.1639 27.7179 22.9267 -11.0056 -9.60672 10.1241 +8046 6 21.894 30.586 27.4834 -30.837 -7.47848 12.2714 +8047 4 22.1658 31.0121 28.3029 9.93408 7.2142 -4.82479 +8048 4 22.5499 30.6966 26.8178 23.3081 1.01511 -13.2982 +8049 6 10.2866 3.2829 27.2371 9.19947 -3.548 -7.92128 +8050 4 10.1566 2.73648 28.0281 -11.5907 7.20828 -5.58516 +8051 4 9.50383 3.79492 26.9844 -8.05462 -4.00143 11.7964 +8052 6 37.7145 25.01 29.7057 15.6828 -51.4836 -24.4954 +8053 4 38.34 24.5625 29.0621 -16.831 21.3675 19.2093 +8054 4 37.2613 24.2159 30.07 -2.41186 22.6264 5.87672 +8055 6 9.13271 24.4444 14.4751 26.0421 8.18538 46.692 +8056 4 9.10912 24.9781 13.7161 -5.31341 21.9098 -32.4591 +8057 4 8.68548 23.6494 14.2981 -19.3974 -37.2941 -14.6224 +8058 6 52.771 31.4727 7.38558 20.6973 -2.13415 1.08713 +8059 4 52.3061 32.183 6.93204 -2.34942 2.78723 -4.55897 +8060 4 52.1263 30.9997 7.89938 -16.8139 -9.70652 3.3966 +8061 6 21.3286 5.45224 36.4983 22.333 -40.4406 3.83692 +8062 4 20.7026 5.40277 37.2139 -7.55906 11.9598 8.05023 +8063 4 21.8475 4.61683 36.6516 -9.65069 29.8227 -15.0031 +8064 6 25.1743 37.2092 4.31919 7.23092 6.80805 -6.24923 +8065 4 25.4754 36.7175 3.5165 -8.68629 0.834167 19.7743 +8066 4 24.8491 36.6197 5.01948 2.53349 -5.19005 -7.77823 +8067 6 34.0165 17.4759 18.2358 -58.4306 -31.0723 45.6386 +8068 4 34.1944 16.9598 19.0779 8.50138 15.1756 -22.5601 +8069 4 33.0528 17.7413 18.4058 39.5305 3.9888 -12.396 +8070 6 37.9578 37.5059 25.2944 -35.6234 -15.4362 -10.7836 +8071 4 36.9622 37.6721 25.197 38.0574 -5.35834 -1.14338 +8072 4 38.1643 36.7565 24.689 -7.79603 13.8086 8.25116 +8073 6 5.07735 4.86484 15.8417 42.9381 3.72816 7.10952 +8074 4 5.88838 4.293 15.9163 -33.8081 0.492332 -6.16483 +8075 4 5.50277 5.71956 15.9997 -16.006 -0.473971 1.61617 +8076 6 14.1507 7.19336 7.76886 38.052 -10.4208 -22.4486 +8077 4 13.5129 7.55624 8.34295 -29.9694 15.266 25.1048 +8078 4 13.7195 6.96448 6.9333 -0.98027 3.69224 9.82406 +8079 6 24.98 10.8641 38.0829 22.9212 14.7137 56.6455 +8080 4 25.3157 11.7906 38.09 -5.76353 -21.6486 -14.5596 +8081 4 24.5861 10.6473 37.2742 -21.4949 -6.61803 -48.2716 +8082 6 35.683 7.97762 22.8121 -8.7657 -2.24292 -6.28447 +8083 4 36.2591 8.71308 23.0369 7.49089 3.45465 4.10549 +8084 4 35.4159 8.13228 21.894 -1.16553 2.61323 2.89561 +8085 6 24.8067 29.1485 22.4175 -2.13284 -11.1741 5.39142 +8086 4 24.8847 28.3567 22.9764 5.78872 7.02228 0.265808 +8087 4 23.868 29.1687 22.2304 -8.38579 3.51829 -7.32943 +8088 6 38.496 31.6463 38.4547 5.18571 -7.52333 -11.192 +8089 4 38.5561 32.3892 37.8222 0.442926 -5.96945 11.3455 +8090 4 38.4779 31.9675 39.3579 -6.04594 15.0172 8.52038 +8091 6 7.23911 33.2316 15.4021 21.919 9.41665 12.382 +8092 4 8.12833 33.2899 15.8377 -30.0201 5.59214 -9.80336 +8093 4 7.41373 32.5516 14.7298 -12.8129 5.82399 11.4308 +8094 6 43.353 23.6104 1.44592 7.44142 11.305 12.851 +8095 4 43.1845 24.4377 0.974361 -3.6145 -11.1369 -5.61195 +8096 4 44.1543 23.8467 1.95013 -11.1925 -12.9992 -13.6036 +8097 6 3.53991 32.9016 14.8697 -2.39625 2.76445 6.29056 +8098 4 3.69073 33.2429 13.9877 -3.53656 0.018747 -12.9915 +8099 4 3.78624 33.6349 15.4383 2.83762 5.11564 5.16825 +8100 6 25.3096 21.77 8.26163 -6.66296 0.990367 -4.9072 +8101 4 26.025 21.1206 8.24337 -4.14835 5.1806 10.2199 +8102 4 24.7855 21.68 9.08833 13.2195 -2.77387 -11.0894 +8103 6 43.8224 15.3683 17.7688 -17.5044 -13.9077 -11.4765 +8104 4 43.5422 15.0425 16.8907 -4.65964 7.2866 4.53357 +8105 4 44.7684 15.2434 17.7192 12.2011 1.97977 1.51727 +8106 6 15.7838 16.2525 16.6573 54.0838 12.7989 52.3812 +8107 4 16.4697 16.8261 16.2793 -6.54184 -0.771336 -3.5329 +8108 4 15.1467 16.1661 16.0105 -48.6612 -2.23154 -48.9531 +8109 6 31.9022 12.8519 11.5241 2.75902 49.2592 5.12049 +8110 4 32.4395 13.2725 12.2474 -7.6131 -20.2803 -12.0836 +8111 4 31.5562 13.6461 11.0457 0.0384164 -26.7823 6.27126 +8112 6 18.2248 5.33623 10.1812 -15.488 18.8418 -23.6702 +8113 4 17.7687 5.75894 9.42369 15.7694 -11.8332 4.62439 +8114 4 17.5271 5.29555 10.8288 -1.36455 -9.23689 12.3446 +8115 6 23.0917 39.0779 10.9282 -11.4905 7.21092 -0.352408 +8116 4 23.963 38.6888 10.8472 1.7552 7.95734 1.65941 +8117 4 23.1114 39.9529 10.5005 0.666922 -10.0515 1.633 +8118 6 46.8677 33.7562 8.76248 1.03354 -2.05441 8.38343 +8119 4 46.5037 34.5328 8.27588 2.5022 -8.853 20.9954 +8120 4 47.1475 33.9422 9.6931 -6.44786 13.1686 -22.3696 +8121 6 31.243 39.9317 20.2224 2.33635 -7.70313 -8.05101 +8122 4 30.8704 39.2996 19.5871 0.699046 7.37293 6.91414 +8123 4 32.2017 39.8574 20.0757 -3.27099 6.09826 0.0696837 +8124 6 15.889 33.0919 19.7864 33.8788 -7.40125 -13.3883 +8125 4 16.1628 33.8221 19.1895 -10.4151 -15.5823 0.760964 +8126 4 16.5176 32.3427 19.5839 -16.9866 18.4919 10.6578 +8127 6 32.5555 39.9164 2.66523 30.0039 -10.6491 -2.95451 +8128 4 33.3508 39.5896 3.12591 -10.8726 3.49711 -8.16538 +8129 4 32.1027 40.3655 3.36837 -16.5932 8.39248 6.84073 +8130 6 50.6959 12.1983 3.90519 17.0412 -18.9771 -24.2847 +8131 4 51.4658 12.4814 3.40053 -2.43524 -2.94964 -4.56419 +8132 4 50.632 12.8314 4.58319 -9.04718 30.5099 32.8795 +8133 6 44.7022 2.76366 12.1205 -8.84849 12.6495 8.41904 +8134 4 44.8494 1.8734 11.8267 15.0216 -15.1797 -4.64519 +8135 4 44.7278 2.73137 13.1008 3.87902 2.35132 -20.2006 +8136 6 11.5141 11.9335 31.6448 -3.41939 3.48047 19.9552 +8137 4 11.2577 12.7405 32.1375 2.53248 -5.05318 0.0588515 +8138 4 11.4496 11.2091 32.2982 6.40928 8.91696 -7.15415 +8139 6 4.75269 10.0418 10.4949 -1.19321 15.9867 3.21309 +8140 4 5.0001 10.2283 11.4058 3.15466 -0.54389 -0.234941 +8141 4 4.46559 10.9018 10.1184 3.18705 -14.0527 1.96128 +8142 6 17.0994 25.0099 20.58 37.5195 36.994 -31.4742 +8143 4 16.2483 24.8536 20.9144 -42.3557 -15.7488 8.6923 +8144 4 16.9647 25.6792 19.8535 4.26961 -24.361 15.5384 +8145 6 48.1092 4.75471 14.8037 19.9531 12.9172 -19.4869 +8146 4 47.21 5.0173 14.8371 -33.3483 -4.43172 15.4156 +8147 4 48.388 5.38041 14.11 12.4129 -13.382 8.75366 +8148 6 18.8523 3.11742 3.41631 -21.2483 -3.07087 -4.7476 +8149 4 18.4665 2.24821 3.59937 1.50537 0.955968 2.27262 +8150 4 19.7704 2.98892 3.60058 26.8928 -3.50499 2.30699 +8151 6 35.4247 26.4577 29.0527 -22.8013 -8.66021 5.68805 +8152 4 35.5248 27.2067 28.475 -2.85698 13.778 -9.76065 +8153 4 36.2768 26.0489 29.0602 21.3259 -10.4415 3.203 +8154 6 32.3896 31.2185 12.8503 57.1958 12.7231 -6.23232 +8155 4 31.5925 31.2509 13.3022 -48.7441 2.01486 27.8379 +8156 4 32.2029 30.8426 12.0127 -5.8383 -14.614 -31.3947 +8157 6 33.0076 28.3366 37.5983 -27.3824 -5.67666 30.0102 +8158 4 32.1052 27.9852 37.8568 28.4022 2.55731 -9.07316 +8159 4 33.3988 28.5694 38.4733 -3.969 -4.9759 -22.0899 +8160 6 45.5072 24.7908 10.3169 -45.8214 60.3209 -7.47747 +8161 4 44.9002 25.317 9.70444 28.5781 -13.9385 29.3176 +8162 4 45.5876 23.9971 9.85482 14.9117 -49.3191 -19.3714 +8163 6 14.779 31.7044 3.16918 -45.5594 -6.97168 29.5477 +8164 4 14.0337 32.2859 2.90387 21.9125 -3.3602 -3.07131 +8165 4 14.4311 31.26 3.996 20.2164 14.1486 -26.6391 +8166 6 31.9242 7.68885 4.30286 23.54 -20.9123 31.4536 +8167 4 31.4705 6.84633 4.17995 2.0164 -2.82895 4.59018 +8168 4 31.5931 8.24323 3.64247 -18.259 33.7262 -37.7068 +8169 6 42.5699 17.3136 32.1968 24.1944 7.3606 3.32713 +8170 4 41.6254 17.2329 32.2603 -19.9776 4.79877 -7.53323 +8171 4 42.7917 18.2007 31.8224 -10.4585 -19.5065 0.0265862 +8172 6 13.8071 23.1746 23.5515 16.4347 -15.6283 -2.15259 +8173 4 13.5183 23.7639 24.245 0.233797 9.11225 10.6616 +8174 4 14.6093 22.7029 23.9066 -20.7684 16.5326 -5.05411 +8175 6 10.7126 7.09833 3.97095 14.1471 -33.6721 -68.9477 +8176 4 10.4245 6.93934 4.82914 -14.4566 -0.97954 55.1879 +8177 4 10.4869 6.2311 3.50145 10.3151 35.4271 10.8748 +8178 6 28.7967 8.6797 17.9015 -30.1103 -2.72244 -33.0478 +8179 4 29.5795 8.35746 17.4579 9.90558 -6.78874 -8.85398 +8180 4 28.1705 8.90161 17.1378 19.1156 -3.64084 26.8114 +8181 6 19.4515 29.3423 26.6295 -39.4767 12.5835 42.7579 +8182 4 19.0038 29.6555 27.482 17.5864 -10.0531 -35.2193 +8183 4 20.2946 29.7741 26.6551 17.8114 4.03003 1.9258 +8184 6 40.6571 40.9865 14.5722 30.7749 0.116883 17.4953 +8185 4 40.9453 41.7159 14.038 -4.90719 13.3855 -18.4876 +8186 4 41.4974 40.7167 14.9881 -11.2006 -4.47055 2.16552 +8187 6 46.2595 14.0857 31.7293 11.6035 -9.35965 4.24636 +8188 4 46.4659 13.1386 31.6985 -1.25294 5.8657 1.71226 +8189 4 45.5092 14.1916 31.1613 -13.5258 4.10617 -10.238 +8190 6 36.7111 36.3198 8.38634 20.5175 24.5507 44.7988 +8191 4 36.5848 37.248 8.66174 -25.6048 -20.3538 -28.8485 +8192 4 37.4262 36.1922 9.03978 -4.76011 -28.7723 -18.9481 +8193 6 30.7791 32.4382 38.0814 8.60258 1.74334 21.9396 +8194 4 31.3949 31.9394 37.5795 9.21482 -20.9838 -26.5205 +8195 4 31.4122 32.9586 38.5821 -11.3785 16.1645 3.6603 +8196 6 47.8794 8.8384 10.1746 26.299 41.1069 27.7005 +8197 4 47.2075 9.11907 9.56312 -13.0744 -2.84885 -16.672 +8198 4 48.1152 7.93695 10.1106 -1.40956 -33.8723 -12.987 +8199 6 24.4191 17.0005 30.9872 -11.3759 2.04439 -13.9008 +8200 4 23.6647 16.9339 30.3566 16.9629 0.0568796 9.7226 +8201 4 24.0218 17.1528 31.8579 2.94571 -1.21426 -7.57694 +8202 6 40.5018 5.09847 4.47991 -26.6992 -20.3188 -5.14046 +8203 4 41.28 5.65048 4.47318 14.3705 11.228 -11.5737 +8204 4 40.0798 5.05838 3.58104 19.0568 4.03597 15.916 +8205 6 52.5742 28.0973 6.9077 -25.4379 -29.0344 16.6943 +8206 4 52.3933 28.6001 6.11132 1.2128 1.19853 -1.81518 +8207 4 51.7383 27.5823 7.10916 28.4347 22.908 -9.38917 +8208 6 36.064 32.3866 23.6124 7.53581 -25.1682 -6.10704 +8209 4 36.4508 32.2046 22.7426 1.48893 5.77393 9.47334 +8210 4 35.7934 33.2936 23.5958 -9.41601 17.7382 0.925908 +8211 6 23.6488 31.8764 22.7665 2.85736 4.06253 -9.33391 +8212 4 23.7634 32.5358 22.0878 -9.04528 15.3932 -0.43099 +8213 4 24.3599 31.3007 22.5126 8.23075 -21.5035 13.0322 +8214 6 0.735457 24.4657 41.7131 -9.37188 -1.3071 -20.2528 +8215 4 1.20497 24.8068 40.9273 -3.735 -3.01915 11.177 +8216 4 54.8235 24.2347 41.4089 15.688 5.53844 3.35783 +8217 6 15.9771 8.98022 19.8191 22.6241 -28.8974 20.594 +8218 4 15.5109 8.26292 19.4118 -7.13343 -10.7615 -13.7959 +8219 4 15.6388 9.77471 19.4696 -19.2292 39.8019 -15.8774 +8220 6 33.1716 12.5629 20.0326 13.9441 -12.6476 -4.49459 +8221 4 32.9044 11.6183 19.8429 16.5289 30.3248 6.35834 +8222 4 34.162 12.7185 19.975 -34.5589 -12.2038 -12.3621 +8223 6 7.03971 24.945 26.3683 -0.33354 -9.69316 23.9049 +8224 4 6.80945 24.3756 27.1101 -9.22275 -9.46444 -2.85995 +8225 4 7.84656 25.3251 26.6963 17.391 9.90995 -3.06061 +8226 6 44.4739 22.5508 36.9255 -16.7075 -6.88118 10.4755 +8227 4 43.5027 22.4108 36.9334 15.1456 1.07948 9.67769 +8228 4 44.6732 22.7799 36.0336 3.04889 5.98288 -21.3947 +8229 6 39.2775 23.7142 25.1185 -44.4168 -97.0378 5.9092 +8230 4 39.6033 24.5307 24.937 33.9242 88.3913 -14.6991 +8231 4 38.7559 23.4597 24.3323 8.03463 3.9453 13.1815 +8232 6 20.3756 2.20712 36.9897 -7.56257 -5.27652 1.95266 +8233 4 20.2168 1.45659 37.5665 4.06747 -3.41627 8.94019 +8234 4 20.2802 1.85339 36.1124 5.28277 1.38 -10.8685 +8235 6 22.8571 19.5527 3.6659 6.2145 7.79245 45.4341 +8236 4 22.8782 19.7834 4.64919 -10.5004 -5.13291 -37.3231 +8237 4 23.7426 19.8021 3.38476 9.02488 -3.84737 -6.15569 +8238 6 31.6989 12.5719 34.5929 20.3571 12.3337 69.8717 +8239 4 31.0774 13.2339 35.0297 17.9304 -15.3013 -22.977 +8240 4 32.3378 12.3324 35.3667 -30.4994 7.85147 -45.3393 +8241 6 12.9846 10.2214 25.1019 -30.6317 10.0697 -32.3453 +8242 4 13.6677 9.95937 25.6652 38.8731 -4.05338 37.0168 +8243 4 12.5116 9.4018 25.0264 -11.673 -9.01961 -8.06086 +8244 6 27.2702 0.587979 13.2088 -29.2359 -8.68669 8.17042 +8245 4 27.7024 41.6312 13.2942 -2.56798 3.03598 -7.56301 +8246 4 26.2795 0.464606 13.259 26.6373 -0.778522 -5.81594 +8247 6 5.6575 24.9337 13.9905 13.1991 2.90197 -9.87868 +8248 4 4.70598 24.9553 13.883 -5.9976 0.782062 8.57209 +8249 4 5.90972 25.4072 14.7914 -9.20077 -1.59682 1.38283 +8250 6 22.9799 17.9518 0.527007 -12.0607 -30.0717 13.8125 +8251 4 22.428 18.6392 0.176667 -3.67819 14.6501 -9.17369 +8252 4 22.2816 17.3415 0.914453 31.709 16.1034 -10.9012 +8253 6 33.0985 25.4181 5.46205 -15.7978 -31.0624 1.20161 +8254 4 33.3789 26.3039 5.55078 15.9502 30.9866 -6.27287 +8255 4 32.9645 25.2082 4.52957 3.04969 3.7853 3.27689 +8256 6 8.52872 7.94688 17.4833 18.4257 15.9711 -24.7978 +8257 4 9.39098 8.3855 17.3119 -11.8135 -8.35054 -2.98105 +8258 4 8.4858 7.94817 18.4262 -6.55829 -2.0729 23.5191 +8259 6 26.8237 0.686378 2.88748 4.07 30.2002 2.01549 +8260 4 26.8412 0.391628 3.80568 -3.86709 0.733005 8.35451 +8261 4 26.5975 1.66265 2.91719 8.86873 -29.5911 -1.41132 +8262 6 50.0397 34.7157 15.6267 -11.8175 -1.09292 -1.87233 +8263 4 50.6372 35.2521 15.0721 -14.1207 -5.91477 -4.02646 +8264 4 49.1323 34.6374 15.219 24.748 6.82197 2.94942 +8265 6 46.275 5.00035 11.1282 9.7079 18.7279 -10.06 +8266 4 45.8191 4.20733 11.3912 -11.1099 -14.8598 8.88229 +8267 4 46.9633 4.71614 10.5231 1.70636 -6.51939 -1.67277 +8268 6 33.7833 38.63 35.3851 22.6491 -26.5736 53.3982 +8269 4 34.0604 38.9625 36.3013 -14.2885 -2.00103 -44.5517 +8270 4 33.6201 39.3455 34.786 -2.63152 22.0909 -4.2817 +8271 6 30.8201 25.8435 41.2101 0.522631 -30.718 -12.9218 +8272 4 31.0968 24.9266 41.4082 -1.05643 6.85883 -6.1679 +8273 4 31.1715 26.3436 0.016995 6.66556 20.3816 22.2796 +8274 6 50.2276 0.978128 24.4598 74.6558 22.0158 36.8282 +8275 4 49.5306 0.534407 24.0585 -38.5843 -30.8873 -31.929 +8276 4 51.1134 0.532188 24.3239 -37.6779 9.32343 -0.630533 +8277 6 31.2996 0.720873 19.0302 14.3507 40.5737 -10.6901 +8278 4 30.4605 0.743437 18.5837 -16.9464 -9.10756 -3.3833 +8279 4 31.3343 41.8987 19.5933 -6.31648 -47.867 22.0648 +8280 6 39.0778 29.5479 19.1423 -24.9794 -6.4558 -1.7207 +8281 4 38.1293 29.5816 19.4551 33.1986 -8.08964 -3.40762 +8282 4 39.446 28.6506 19.2986 -6.02354 14.8003 0.990496 +8283 6 21.659 17.5991 25.8953 -11.5386 33.2832 -7.33353 +8284 4 22.0418 18.5204 25.967 -8.02723 -30.5851 6.12101 +8285 4 20.778 17.7492 25.4824 18.7799 -9.30112 4.66445 +8286 6 35.0777 28.803 27.4254 -1.70316 -21.0069 37.4458 +8287 4 35.3301 29.4791 28.0775 3.3924 -2.39002 -8.5847 +8288 4 35.0935 29.2141 26.5843 6.79083 21.8236 -32.9604 +8289 6 30.7137 25.4449 11.6588 -11.4017 25.922 39.321 +8290 4 30.5753 25.9017 12.5616 8.60864 -26.5127 -36.0552 +8291 4 30.5331 26.1452 11.022 4.69716 -0.666916 0.479504 +8292 6 7.33812 15.1344 12.3538 4.68116 -40.544 31.6975 +8293 4 6.75693 14.3594 12.209 2.06777 16.361 -3.14284 +8294 4 7.31295 15.622 11.5607 -9.0052 27.071 -31.8075 +8295 6 16.8334 26.8188 7.04972 -25.5936 3.66279 -30.8653 +8296 4 17.5758 26.708 7.59816 38.4339 -11.2263 23.8467 +8297 4 17.1819 26.9966 6.1597 -5.58153 -2.73835 6.66814 +8298 6 29.5302 33.0784 31.0001 -37.3865 -15.0005 -19.6245 +8299 4 28.6433 32.7554 30.7459 2.04647 15.9344 -4.27919 +8300 4 29.8764 32.2746 31.3613 18.5632 -10.7791 20.7082 +8301 6 14.1048 2.11879 30.9099 -3.69766 -14.7615 43.6071 +8302 4 14.1458 1.95878 31.9138 -8.46722 9.63961 -39.7078 +8303 4 13.6642 1.31591 30.5661 9.09938 8.95306 -0.112961 +8304 6 15.6571 22.2632 2.89617 -37.5764 43.5932 -9.62192 +8305 4 16.4348 21.7941 3.05118 39.5293 -34.0009 4.7875 +8306 4 15.0286 21.6897 2.4522 -3.10464 -12.538 6.06705 +8307 6 23.7259 29.1153 40.9645 17.3396 38.8389 1.6287 +8308 4 23.2818 30.0193 40.9831 11.4767 -32.1544 -0.906545 +8309 4 24.7087 29.2887 40.9216 -25.4222 -7.32646 2.20707 +8310 6 38.1247 14.1642 13.7107 12.8592 31.0763 6.54808 +8311 4 37.6278 13.3808 13.8383 -17.8092 -31.0521 2.1891 +8312 4 38.9029 13.9224 13.2095 7.41852 -3.42228 -8.90759 +8313 6 35.2503 26.5068 15.521 -3.09354 13.3371 19.8917 +8314 4 34.5349 26.5126 14.8818 -0.932758 -4.81772 -4.34805 +8315 4 34.9075 27.0382 16.2823 10.0491 -13.0104 -19.4153 +8316 6 19.0968 34.7379 16.486 5.71756 23.995 22.7437 +8317 4 19.4075 35.6523 16.3704 4.72819 -11.1284 17.3551 +8318 4 19.0401 34.4508 15.6072 -6.41662 -20.6903 -39.0731 +8319 6 18.1723 29.7514 35.7083 20.6671 12.6318 -10.71 +8320 4 18.3041 30.5743 35.1773 -7.60682 -14.8418 20.474 +8321 4 19.0351 29.5718 36.145 -10.3356 2.9076 -6.19235 +8322 6 54.1213 22.2675 24.9131 12.7342 -33.1199 -26.8219 +8323 4 53.6265 21.7967 24.1967 9.15099 10.4438 12.7736 +8324 4 53.5183 22.8995 25.2476 -23.1208 24.5105 7.38222 +8325 6 30.3446 10.3415 34.0026 7.84994 -0.761596 -9.91104 +8326 4 29.5868 10.4349 34.5739 -14.9697 1.07498 11.7851 +8327 4 30.8511 11.1643 34.0933 -4.52293 -3.62201 3.70872 +8328 6 38.3178 33.8965 18.5989 -35.8058 -11.4104 -3.76591 +8329 4 38.923 33.166 18.7063 19.7544 -4.29321 9.06839 +8330 4 38.8137 34.6503 18.3352 23.7539 21.4454 3.52643 +8331 6 22.4873 14.1653 34.4312 -21.9658 -17.0918 -49.1801 +8332 4 22.5571 13.4626 33.7145 -4.81718 29.7264 22.473 +8333 4 23.0772 13.8965 35.1058 26.7449 -1.29975 22.8703 +8334 6 38.021 0.617904 2.36461 -2.26574 -7.91048 -40.4777 +8335 4 37.6239 1.19646 3.0125 3.99393 1.59858 23.4614 +8336 4 38.7851 0.132723 2.71367 -6.22024 4.30596 13.4956 +8337 6 38.885 41.133 10.292 38.4397 69.693 -20.9517 +8338 4 38.7327 0.223589 10.3334 0.502898 -40.1285 -2.38265 +8339 4 38.1678 40.7662 10.7395 -40.074 -22.1176 34.0334 +8340 6 53.417 21.9266 38.962 18.4876 1.53578 17.2983 +8341 4 52.9974 21.8755 38.1026 3.71535 5.74942 -10.4205 +8342 4 54.37 22.1639 38.7939 -25.8904 -11.793 -3.59034 +8343 6 39.9933 12.7125 36.2959 -18.8272 27.1562 12.2819 +8344 4 39.0734 12.4542 36.2547 -7.90274 -1.75871 9.35878 +8345 4 40.3901 12.0873 35.7283 26.8007 -18.4843 -23.2317 +8346 6 48.44 17.2431 40.5981 -19.9836 6.93831 4.04917 +8347 4 47.6199 17.7956 40.4399 22.5854 -23.5642 7.97707 +8348 4 48.3147 16.8142 41.4747 5.07747 10.2388 -9.33604 +8349 6 32.0284 9.3439 40.0151 10.5149 -12.1651 13.6504 +8350 4 32.8546 9.41316 39.523 -1.99935 -3.17675 -6.39298 +8351 4 31.9706 8.39334 40.2816 -10.0936 21.7982 -4.27543 +8352 6 31.75 22.4929 6.3685 -34.2181 3.54143 23.53 +8353 4 31.3779 21.709 6.82557 12.2201 6.35834 -11.7559 +8354 4 31.3059 23.2194 6.8777 16.0591 -13.7554 -15.3432 +8355 6 51.0144 2.58529 21.579 28.4772 -3.64411 10.4611 +8356 4 51.4343 1.72703 21.8198 -11.0001 9.38403 -4.71992 +8357 4 51.7571 3.20177 21.4507 -11.3685 -6.83795 2.38662 +8358 6 13.6247 22.0465 12.1442 29.0901 0.46256 9.76546 +8359 4 14.4578 22.3795 12.5465 -13.9989 1.27328 -8.95219 +8360 4 12.915 22.6494 12.3833 -3.04453 8.5056 -1.94564 +8361 6 23.6209 24.0381 14.6453 -17.5202 11.834 -36.5316 +8362 4 24.2009 24.4886 15.2598 9.8869 4.60732 -3.70937 +8363 4 23.5497 24.6116 13.8304 3.00595 -20.2815 30.972 +8364 6 9.32136 4.85156 31.2387 8.97842 0.466865 -3.67014 +8365 4 8.41764 4.8259 30.9291 -8.7496 -0.132795 -7.84821 +8366 4 9.23666 5.38964 32.029 2.44443 -3.9247 9.21777 +8367 6 16.6769 26.3146 18.0426 -28.7898 -24.0576 -1.25383 +8368 4 15.7763 26.5978 17.7405 22.2361 3.17889 2.46191 +8369 4 17.2688 27.0532 17.9767 7.52301 23.5471 -7.71583 +8370 6 5.12002 13.5179 11.5454 -28.2867 15.553 -42.5279 +8371 4 4.34318 13.4159 12.0982 -3.89331 -5.54815 13.62 +8372 4 4.69334 13.8537 10.6805 23.3071 -7.58808 40.5266 +8373 6 29.613 23.6535 8.07622 4.06305 -5.39054 -18.0309 +8374 4 29.2087 23.3655 8.89798 -2.48969 6.78204 1.65997 +8375 4 29.356 24.5861 7.97247 8.33853 -10.6544 5.22118 +8376 6 0.809058 7.56442 27.8431 6.90575 4.16885 -14.0934 +8377 4 0.916059 7.33161 28.7668 -1.2645 -7.40385 9.39857 +8378 4 1.47033 8.27499 27.7095 -9.19662 -21.8408 -1.77541 +8379 6 15.4183 9.78145 0.490529 10.0725 -7.13925 0.979932 +8380 4 16.087 9.43012 41.8027 -0.259761 -4.12548 -6.98761 +8381 4 15.4693 9.20893 1.26423 -1.27146 5.63374 6.96511 +8382 6 18.8191 0.059487 34.1187 -25.6574 -0.396319 -31.4644 +8383 4 18.4098 41.5755 33.3103 16.2128 4.97009 18.3796 +8384 4 18.5054 0.975155 34.0945 0.533414 5.37151 1.64989 +8385 6 18.7349 30.7803 29.1665 47.4813 -67.7405 25.7886 +8386 4 19.5534 30.6866 29.7899 -42.3671 12.2249 -32.0712 +8387 4 18.5184 31.6699 29.0545 -8.91834 48.7901 3.3651 +8388 6 48.4474 16.4903 36.136 -4.39653 9.55775 -4.4164 +8389 4 47.5651 16.9082 36.2181 15.0357 -0.381514 0.207393 +8390 4 48.471 16.1274 35.2331 3.08724 1.10756 7.15907 +8391 6 43.7979 0.472205 29.2706 42.555 -4.96452 -15.1149 +8392 4 42.8863 0.267919 29.38 -32.9664 -6.64218 10.9475 +8393 4 44.2792 41.5357 29.3524 -8.26894 11.2804 8.78801 +8394 6 16.7205 13.887 21.3769 2.19577 2.66609 -2.49996 +8395 4 16.2052 14.7022 21.5336 6.85381 -11.1318 0.719729 +8396 4 16.6911 13.4037 22.2072 -6.06459 1.50462 5.19021 +8397 6 17.3883 13.4356 26.2524 27.4966 3.2637 -26.6685 +8398 4 18.1303 13.5822 25.5825 -26.8694 -2.13737 32.6247 +8399 4 17.6394 12.6216 26.7148 -3.51452 -0.718268 0.201186 +8400 6 48.1557 10.2329 23.6958 7.66187 -11.6345 21.9365 +8401 4 48.0869 10.5828 24.5972 -4.20109 -8.3855 -4.21906 +8402 4 47.9242 10.9774 23.1563 3.12678 5.33996 -12.4543 +8403 6 28.2651 17.9126 17.8865 15.704 23.8601 -19.8805 +8404 4 29.0328 18.4581 17.6288 -8.16305 -6.08358 1.86534 +8405 4 28.6272 17.0995 18.2183 0.672722 -20.799 10.0784 +8406 6 54.0866 38.1772 23.6885 15.2416 -7.03948 -9.32302 +8407 4 0.015845 37.9236 23.4759 -13.1891 10.5947 7.1207 +8408 4 53.5403 37.6177 23.1226 -4.14834 -2.69562 5.50015 +8409 6 8.47885 18.3973 11.4073 -18.4373 -13.8141 42.9629 +8410 4 7.63335 18.6519 11.0416 -6.40415 6.02722 -6.48684 +8411 4 9.12927 18.583 10.7796 32.3175 8.52747 -41.6205 +8412 6 45.9451 12.8796 11.0371 -17.0736 -2.86831 -37.3051 +8413 4 46.6905 12.613 10.4807 4.61659 2.073 6.35499 +8414 4 45.2044 12.775 10.3831 8.06265 2.44535 24.075 +8415 6 16.2127 8.79404 14.0297 41.7324 -66.6139 22.361 +8416 4 15.4739 9.28873 13.8367 -45.7772 50.9633 -18.0772 +8417 4 17.0286 9.27652 14.012 9.93977 26.888 -8.08533 +8418 6 42.7214 13.3612 21.3881 16.6788 44.7105 -2.77317 +8419 4 41.8036 13.1589 21.3301 -20.1042 -28.5105 -1.62877 +8420 4 42.6833 14.2978 21.1276 5.52546 -8.26362 1.62797 +8421 6 21.0018 40.4256 16.4674 21.2457 -19.0828 1.73859 +8422 4 20.7372 40.049 17.3276 2.67731 3.65462 -7.46566 +8423 4 21.8606 39.9985 16.1939 -29.0987 10.293 9.55187 +8424 6 45.6337 11.4313 32.9356 51.1157 -40.0447 2.01383 +8425 4 46.3303 10.7696 33.2563 -29.172 28.0234 -20.2541 +8426 4 45.1866 11.676 33.7277 -20.3741 9.53259 21.5498 +8427 6 26.9484 8.87146 24.2965 48.4346 1.85391 18.4292 +8428 4 27.5311 9.68141 24.3337 -29.9021 -15.2605 -8.39328 +8429 4 27.4823 8.26118 24.8676 -16.4416 6.67878 -12.0087 +8430 6 18.977 2.43413 29.3663 0.758316 16.52 -7.40381 +8431 4 18.1944 2.4248 29.9271 -0.767207 -2.12047 7.99903 +8432 4 19.1173 3.36872 29.101 -3.03797 -9.07666 7.57415 +8433 6 8.2454 29.1679 19.723 -8.63488 -12.9151 21.1286 +8434 4 8.14448 28.8871 20.6627 3.14293 7.67545 -21.2948 +8435 4 7.83715 28.464 19.1969 -1.03495 3.62674 2.54809 +8436 6 9.03976 34.3129 18.6533 -7.54593 -6.72093 -3.09965 +8437 4 8.77081 34.2931 19.577 -0.177883 2.97642 -7.59668 +8438 4 9.06659 35.2455 18.4187 6.50563 1.62734 -4.46359 +8439 6 10.1892 11.9266 11.2355 -21.5107 11.0325 -1.739 +8440 4 10.2333 12.874 11.065 17.4692 -2.43612 -1.88546 +8441 4 9.23632 11.7983 11.121 5.09535 -6.80078 4.24402 +8442 6 35.7546 21.6858 36.1669 -23.2352 21.9394 0.834429 +8443 4 35.0265 22.3595 36.1433 18.2091 -18.4066 2.26802 +8444 4 36.3924 22.0173 36.8321 -9.99636 -6.87572 -9.75527 +8445 6 17.0812 12.5048 36.3903 -12.1142 25.6516 12.5185 +8446 4 17.3175 12.8308 37.2812 -0.49448 -9.18651 -10.1264 +8447 4 17.5662 11.7075 36.2155 7.76979 -20.5663 -1.07791 +8448 6 37.1566 13.0227 34.2843 -17.9764 -6.1284 -55.2853 +8449 4 36.5549 12.2662 34.3472 4.68366 1.60167 -17.3784 +8450 4 37.3932 13.1268 35.1567 14.9075 13.7384 64.605 +8451 6 38.9862 29.5501 13.2301 -1.89389 21.6683 -7.70005 +8452 4 38.7944 28.7085 12.8419 -2.19861 -17.9948 -10.7911 +8453 4 38.6501 29.4932 14.1174 1.27468 3.77518 16.782 +8454 6 0.176516 29.3495 29.4845 -12.5141 10.2637 -5.31555 +8455 4 0.737394 28.6151 29.2028 3.82179 3.49987 -8.15609 +8456 4 54.9814 29.9211 28.6995 5.57042 -17.7863 13.6106 +8457 6 15.9458 0.256833 12.7596 -44.0073 4.56069 2.48191 +8458 4 15.316 0.578271 12.0799 19.6091 -0.692249 -3.06606 +8459 4 15.3039 41.7798 13.3939 19.5978 -0.7471 3.56907 +8460 6 3.99127 11.9482 8.78851 -15.4327 -39.7622 32.4444 +8461 4 4.35413 11.6179 7.97869 6.27746 3.41828 -23.4587 +8462 4 3.98972 12.8788 8.75552 1.02746 43.1268 -6.73396 +8463 6 24.041 23.6822 19.9783 33.1595 11.366 0.122861 +8464 4 23.6132 22.8866 19.7159 -20.0299 -17.1205 -2.84168 +8465 4 23.4218 24.2757 20.3917 -9.46777 4.2557 4.80954 +8466 6 4.48057 2.29323 23.9805 -22.9759 10.1361 69.4322 +8467 4 4.73792 2.40802 23.1034 3.49419 10.2026 -52.1527 +8468 4 3.69711 2.85929 24.1902 11.7092 -10.5693 -13.4065 +8469 6 33.0966 27.663 33.8386 -28.073 -12.9468 -7.71443 +8470 4 33.3687 28.5694 33.7309 6.85765 13.8135 -2.76136 +8471 4 33.7449 27.1385 34.2981 13.436 1.78162 12.2729 +8472 6 11.3912 21.7129 6.08719 -17.5666 -2.19741 -2.39462 +8473 4 12.3323 21.6847 6.05692 28.5529 -3.65784 2.285 +8474 4 11.1694 22.1681 5.26899 -4.22105 -2.6604 -2.39966 +8475 6 37.2225 13.5364 23.6261 -18.6729 23.2035 4.88571 +8476 4 37.3138 14.0862 24.4412 -7.0733 -14.7121 -13.3014 +8477 4 37.9734 12.9786 23.5155 30.7338 -8.31921 -1.90296 +8478 6 5.00503 21.0366 33.3647 1.8453 38.5327 -33.3657 +8479 4 4.21257 21.4237 32.9267 15.1329 -13.9269 -2.57683 +8480 4 4.69097 20.5075 34.0602 -12.1996 -25.3348 31.8286 +8481 6 18.1998 37.5792 26.9379 10.6598 2.97497 -14.5277 +8482 4 17.7896 38.4267 27.1371 3.99806 -1.69574 -0.528064 +8483 4 18.8493 37.7746 26.2284 -6.0853 -8.42077 12.5802 +8484 6 19.7447 16.1537 4.6847 3.25094 -1.99961 -5.02271 +8485 4 18.927 15.8729 5.11398 3.02189 5.09699 3.93014 +8486 4 20.4865 15.8366 5.22215 -5.31395 3.35724 3.77112 +8487 6 54.074 32.5125 15.5854 10.3761 -37.3618 -30.9158 +8488 4 54.8842 32.2065 16.0104 -1.29748 4.29224 -6.87141 +8489 4 53.7047 33.0976 16.2003 -18.9781 34.1452 25.1436 +8490 6 31.1314 3.81684 36.7321 -0.834289 -2.49025 -7.10722 +8491 4 31.1103 4.02948 37.6722 -6.54843 -2.60835 4.18586 +8492 4 30.7135 2.95482 36.5673 3.74099 5.55874 7.56308 +8493 6 11.8386 14.3591 5.9475 31.6488 6.08621 47.6135 +8494 4 11.9235 13.4381 5.72501 -3.84758 -8.60837 -9.73648 +8495 4 12.4264 14.4198 6.78937 -30.0453 0.761866 -39.8937 +8496 6 30.4739 33.6971 6.46755 -23.3776 20.1936 16.0158 +8497 4 30.0841 33.0849 7.09297 -6.22519 -2.1618 10.9649 +8498 4 31.0937 33.1726 6.0102 25.8315 -23.5027 -25.5745 +8499 6 12.7945 0.536645 21.6661 -31.9857 18.4102 -14.2222 +8500 4 12.046 0.975194 21.1709 21.6431 -18.6961 6.09473 +8501 4 12.7507 0.998686 22.5059 13.427 -0.157027 11.5383 +8502 6 52.7685 7.22113 26.1957 6.97037 27.5507 21.845 +8503 4 53.4259 7.92282 26.4698 -21.5773 -21.2317 -16.9414 +8504 4 53.0823 6.78628 25.4103 4.46247 -3.68205 -10.7225 +8505 6 39.7279 40.8849 3.7445 22.9677 17.8938 -40.8272 +8506 4 39.3244 40.0392 3.76563 -12.6427 -25.5287 10.0743 +8507 4 39.6614 41.3038 4.58361 -3.65945 6.85452 27.763 +8508 6 20.1085 31.9188 21.9984 -7.05206 -5.67602 7.13377 +8509 4 19.4287 32.0842 22.6964 14.9272 -8.91322 -13.6161 +8510 4 20.3617 32.7769 21.6609 2.64243 15.0084 0.0829653 +8511 6 12.8674 35.0052 4.44359 43.5281 -46.0898 9.1613 +8512 4 12.2643 35.7062 4.40975 -34.4326 42.8527 -2.74399 +8513 4 13.784 35.3443 4.35073 -14.7319 6.47242 -4.65586 +8514 6 24.0589 33.6612 24.8588 9.55704 11.7193 -6.52578 +8515 4 23.7303 32.9012 24.3903 -5.13736 -12.3884 -10.0474 +8516 4 24.8786 33.8838 24.3903 -2.58553 -1.28908 -1.69824 +8517 6 40.1426 40.9082 22.7393 38.5538 -20.8809 37.5387 +8518 4 39.5402 41.0833 22.0513 -32.6743 7.60774 -19.3027 +8519 4 39.6696 40.5795 23.5226 -1.01773 2.4492 -9.99125 +8520 6 15.5532 2.81426 38.4448 -20.0738 34.0709 23.3703 +8521 4 14.8967 3.48174 38.7749 9.17215 -23.4566 -12.8824 +8522 4 16.1607 3.33672 37.9186 19.8661 -0.634992 -1.43825 +8523 6 41.016 9.18565 16.9561 17.4117 -10.7022 -18.9926 +8524 4 41.8597 8.69641 16.8054 -9.41989 12.8418 6.23764 +8525 4 40.6131 8.73354 17.6887 -9.17188 -2.41438 15.2761 +8526 6 43.1923 41.3931 9.58697 -22.3356 -19.1489 -3.62619 +8527 4 42.3612 40.9845 9.24256 14.3618 0.824315 8.65898 +8528 4 43.3433 0.185675 8.9708 1.58778 19.1204 -6.9238 +8529 6 24.903 37.9158 30.7914 -43.8554 -5.41491 21.3724 +8530 4 23.952 37.804 31.173 48.4757 4.96182 -14.1951 +8531 4 24.7905 38.4252 29.9913 -4.69729 3.46822 -12.8277 +8532 6 2.22055 5.32897 16.4318 -0.704957 11.5959 2.51569 +8533 4 1.8086 4.56809 16.8519 3.25773 -6.94195 4.1641 +8534 4 3.17492 5.17974 16.3235 -2.45649 -10.6256 -1.35481 +8535 6 1.39662 14.9371 19.1386 6.71081 10.2639 18.1623 +8536 4 0.558182 14.6006 18.8448 -10.0768 -10.7254 -15.2923 +8537 4 1.25744 14.8844 20.1022 8.06638 5.64899 -3.4629 +8538 6 34.3184 26.5435 23.7018 12.956 38.2174 -10.8067 +8539 4 33.6096 26.6326 23.0506 -6.28704 -5.42218 7.19498 +8540 4 34.253 25.729 24.1673 -8.0715 -30.4977 4.91012 +8541 6 41.932 21.8144 37.5476 -28.1346 24.458 10.6264 +8542 4 41.9653 21.2973 38.3662 8.82952 -0.726087 -9.88338 +8543 4 41.2985 22.5209 37.8344 14.7394 -10.5077 -10.9774 +8544 6 39.4289 37.6722 12.6363 -7.06663 36.6798 -8.56095 +8545 4 38.7214 38.0767 13.1674 9.12422 -13.2372 3.4836 +8546 4 39.8791 38.4903 12.2996 -0.376717 -30.7746 7.3995 +8547 6 30.2308 35.8744 2.88429 56.3256 -5.17531 19.584 +8548 4 29.7395 35.078 2.8871 -14.5394 -27.2578 -4.40621 +8549 4 29.6846 36.541 2.55195 -33.266 39.3858 -14.7027 +8550 6 50.3691 12.2996 11.0379 -10.7742 -32.245 -38.7061 +8551 4 50.5492 13.1381 11.4098 4.20277 26.7051 25.7379 +8552 4 50.0731 11.6929 11.7162 -2.05651 -3.66514 15.0978 +8553 6 38.4203 1.52686 34.6552 6.3891 -23.1477 32.9209 +8554 4 38.2942 1.9363 33.8354 -7.66336 30.6162 -40.7111 +8555 4 38.1079 0.632206 34.5078 -6.35148 -11.0336 -1.97829 +8556 6 23.4679 32.2557 29.2149 -43.4567 -12.6916 53.2324 +8557 4 24.0296 32.8423 28.7424 12.6247 17.2837 -9.6693 +8558 4 23.1232 32.6929 30.0761 24.9901 -11.6617 -44.232 +8559 6 36.561 38.8488 8.89417 42.7368 2.70764 46.8348 +8560 4 35.962 39.5202 8.64255 -29.9788 24.4889 -23.0747 +8561 4 36.8832 39.1244 9.78764 -11.193 -6.37855 -17.8717 +8562 6 35.882 15.8491 32.4345 4.38917 24.4094 -11.8898 +8563 4 36.1253 15.4284 33.2547 4.1797 -3.844 11.2859 +8564 4 36.4849 16.63 32.3181 -12.6028 -21.8682 2.29862 +8565 6 22.2747 21.8257 41.5848 1.63659 45.0851 -0.0273952 +8566 4 22.1351 22.8132 41.5538 -4.13496 -33.3395 13.1468 +8567 4 23.0832 21.7834 41.079 15.3069 -18.439 -3.51535 +8568 6 24.3693 38.6933 37.0124 5.99709 22.8296 -9.01594 +8569 4 25.2224 39.1901 37.0147 -13.2325 -18.2305 -0.0611307 +8570 4 24.4452 38.0141 37.6805 1.8393 -10.9749 7.25289 +8571 6 45.85 22.0674 16.0435 -6.35855 -11.009 -33.5755 +8572 4 46.1693 22.2375 15.1223 -5.70657 5.73574 25.2515 +8573 4 45.3177 21.2496 15.9445 13.424 8.98362 5.88408 +8574 6 34.0938 26.1451 39.6028 29.3502 -8.72422 32.5359 +8575 4 33.1775 26.2044 39.4639 -36.6108 3.5864 -15.8394 +8576 4 34.1454 26.1252 40.583 9.60862 3.8872 -14.9166 +8577 6 7.22316 36.161 23.2803 -75.9344 2.48999 -44.2827 +8578 4 7.2061 37.0658 22.9632 2.60813 8.07149 -4.69042 +8579 4 7.98979 36.1134 23.7455 79.8131 -8.28428 52.3852 +8580 6 29.1469 40.7664 9.14908 25.9603 -62.9641 -41.536 +8581 4 29.104 40.2522 8.28913 -11.1672 35.4313 19.904 +8582 4 29.7179 40.1086 9.59652 -3.22944 23.7461 21.8778 +8583 6 29.3725 11.2348 1.3024 -38.7794 14.8627 17.4065 +8584 4 28.4703 11.3821 0.891273 31.6728 -0.63192 16.6295 +8585 4 29.2803 11.4968 2.26097 5.36173 -12.1272 -32.3877 +8586 6 30.9813 3.70043 14.0775 0.393287 -12.1193 -7.6118 +8587 4 31.3533 2.81844 14.3971 -7.37725 32.1126 -17.4345 +8588 4 30.796 3.71521 13.098 8.52465 -17.2224 25.8707 +8589 6 29.7018 15.2871 38.2765 -11.7342 18.5436 -44.4423 +8590 4 30.2882 15.1814 38.9925 24.3773 -7.28175 32.8118 +8591 4 30.1059 15.9805 37.6877 -12.7379 -16.9908 17.8861 +8592 6 36.618 0.316233 29.1564 -1.13478 17.6011 -18.8673 +8593 4 37.4497 0.805382 29.2328 -0.537074 -5.31334 10.7084 +8594 4 36.0611 0.935156 28.6408 3.38103 -20.3125 11.7491 +8595 6 47.6566 0.117823 23.249 5.11875 5.73062 -10.5794 +8596 4 46.969 0.414744 23.8324 -12.4062 9.53281 16.9836 +8597 4 47.4018 41.1354 23.0496 0.315762 -17.3342 0.264415 +8598 6 7.91605 37.1729 29.9478 9.96828 38.7234 29.3851 +8599 4 7.8238 37.3188 30.9485 4.22886 -13.4646 -46.5453 +8600 4 8.48708 37.9472 29.6677 -24.8232 -29.7333 9.09982 +8601 6 38.925 24.2263 12.6374 28.6028 -18.1679 -25.4959 +8602 4 37.978 24.1747 12.7226 -16.6271 -1.4443 2.40459 +8603 4 39.1586 23.5255 11.9538 -9.24307 26.9603 22.464 +8604 6 21.3053 26.2545 36.7859 14.9917 45.9325 1.16 +8605 4 20.8074 25.7232 36.1994 -14.2562 -21.9874 -17.8757 +8606 4 21.6248 25.6951 37.4625 3.91421 -21.0802 23.8691 +8607 6 28.2258 23.3284 24.9888 19.6442 1.87868 9.60148 +8608 4 28.2493 24.0261 25.6588 -3.93467 -3.60043 -2.01642 +8609 4 29.1002 22.8932 25.0573 -18.3502 1.43704 -4.70914 +8610 6 38.4116 39.5691 14.5896 29.669 -4.24194 25.1928 +8611 4 38.4978 38.8692 15.3261 -6.52385 31.9806 -37.1925 +8612 4 39.2924 40.0897 14.6163 -46.5668 -30.9815 -6.21074 +8613 6 26.0432 5.99751 38.1148 44.5658 1.98351 30.7371 +8614 4 26.452 6.86444 38.1066 -12.5768 15.2327 -11.4433 +8615 4 26.7959 5.51316 38.5398 -27.2991 -6.53191 -16.0548 +8616 6 52.1237 17.2497 22.5073 -27.4301 16.765 14.7973 +8617 4 52.9399 17.665 22.2571 16.5652 5.20466 -11.3284 +8618 4 52.1578 16.3131 22.3678 7.8945 -19.2066 -9.92552 +8619 6 39.5302 30.1999 31.4498 -15.3908 2.56685 75.4769 +8620 4 40.0207 30.5437 32.2484 0.473519 -4.28305 -35.1019 +8621 4 38.713 29.8928 31.926 18.6512 10.8404 -28.7426 +8622 6 19.6503 6.93083 12.7623 15.8343 -24.4908 21.6207 +8623 4 19.8732 6.46228 13.5959 -20.1786 11.9342 -5.76682 +8624 4 20.303 6.55009 12.1776 -0.0209149 2.55819 -14.5973 +8625 6 32.4196 37.4972 40.0987 12.4446 10.4582 -32.0511 +8626 4 32.8186 36.647 40.0719 9.51079 -23.9505 -16.9607 +8627 4 32.1638 37.519 40.9804 -20.9873 13.1856 56.2462 +8628 6 39.7646 0.344956 6.09395 -0.813604 -13.3118 11.6504 +8629 4 40.0929 1.25666 6.05063 3.72657 -6.06719 5.14874 +8630 4 40.1279 41.7919 6.88268 -2.2039 13.7644 -10.8213 +8631 6 28.7754 10.1494 29.1547 6.27663 8.45441 -17.0952 +8632 4 27.8341 10.1814 28.9557 -5.13507 -0.906004 3.81537 +8633 4 28.9096 9.91312 30.0774 -3.02611 -6.60467 -0.689697 +8634 6 28.3509 21.0738 10.6423 20.1214 -0.517468 -23.7169 +8635 4 28.7452 21.9678 10.604 -10.1652 -7.70852 11.001 +8636 4 28.9796 20.5469 10.1008 -17.263 7.26144 14.8814 +8637 6 27.0689 28.6853 20.8654 35.4789 -5.63144 4.47554 +8638 4 27.7442 29.2307 21.3162 -7.53329 -4.62114 -3.00727 +8639 4 26.2324 28.9644 21.1916 -29.8949 8.87289 15.491 +8640 6 39.6884 13.9755 33.4499 14.6401 2.99861 16.5486 +8641 4 40.0373 13.7827 34.3426 -3.85296 -1.51256 -14.2832 +8642 4 38.7457 13.8219 33.5285 -9.87208 -9.87778 -3.27097 +8643 6 25.4679 11.6581 34.316 -5.2989 -28.5582 40.5924 +8644 4 24.7613 11.1605 34.7897 20.9725 -0.466275 -6.59756 +8645 4 25.003 12.0579 33.6214 -16.717 25.3404 -32.2266 +8646 6 27.5101 37.647 21.4263 -39.7295 -31.2682 -35.969 +8647 4 28.2375 37.1633 21.0518 17.2189 -6.02702 -9.55939 +8648 4 27.8241 38.1534 22.1272 30.3423 24.6719 41.8853 +8649 6 30.5838 20.0489 28.6446 73.221 13.9737 -1.42059 +8650 4 31.1441 19.3945 29.1273 -28.9524 12.9537 -8.0961 +8651 4 29.6632 19.9528 28.6439 -45.0502 -19.2043 6.90743 +8652 6 42.3833 1.8554 14.9243 13.367 3.08275 38.4467 +8653 4 41.8907 2.29225 15.634 5.99337 6.74303 1.17955 +8654 4 41.7769 1.84183 14.2131 -17.6385 -4.20156 -32.9301 +8655 6 12.1633 12.5377 19.5325 -23.0245 -19.867 -11.1113 +8656 4 12.9521 12.0237 19.3369 9.43068 0.576721 5.46819 +8657 4 11.4219 11.8853 19.4518 12.4737 16.4774 1.27947 +8658 6 19.216 1.20416 16.3541 12.5689 2.54581 22.2585 +8659 4 19.6937 0.628292 16.9879 -4.91383 6.35485 -14.1526 +8660 4 19.7889 1.98236 16.2594 -2.22189 -4.72354 -7.2618 +8661 6 9.47695 16.1439 27.6873 23.0793 15.684 -40.8775 +8662 4 9.87411 15.9669 26.7875 -8.00596 11.4199 30.6292 +8663 4 9.27844 15.2819 28.0019 -12.6146 -24.0632 14.4486 +8664 6 40.4558 26.1873 24.7848 -5.87099 -8.07067 -10.9608 +8665 4 40.3772 26.6753 25.6381 -3.45584 0.121614 -18.2296 +8666 4 40.075 26.6842 24.0102 9.21367 0.234889 33.0434 +8667 6 47.6742 17.6493 18.027 -37.0889 26.6143 -3.73366 +8668 4 48.2089 18.0323 18.7522 -4.76487 -3.2939 -8.20899 +8669 4 46.8388 18.2201 17.9217 41.9344 -19.3622 12.4897 +8670 6 36.6073 25.2802 4.19388 18.2149 -9.73143 -24.5863 +8671 4 36.604 25.3887 5.14943 -0.00537736 13.7381 3.83127 +8672 4 37.3627 25.7621 3.76942 -18.9403 0.329358 18.8416 +8673 6 39.5721 35.375 29.6682 7.39129 29.0443 4.37935 +8674 4 38.9992 34.6325 29.7528 -8.39079 -18.7886 -5.10368 +8675 4 39.3389 35.9401 30.4162 6.41301 -4.37294 -4.4287 +8676 6 0.402862 14.6299 13.3406 12.3375 -5.37043 -32.3015 +8677 4 54.737 15.2477 13.6388 -5.18731 7.44473 4.40324 +8678 4 0.540834 14.0191 14.0401 1.19186 -14.994 25.3978 +8679 6 12.2127 27.3484 8.43247 -29.2387 -0.771708 1.75024 +8680 4 12.965 26.7512 8.46983 14.5311 5.0326 6.8656 +8681 4 12.3156 28.1607 8.97491 11.1816 -11.3427 -11.9337 +8682 6 36.8986 14.8167 21.1188 31.0797 27.7575 -31.2238 +8683 4 37.0397 14.394 21.9547 2.6333 -10.7207 26.6181 +8684 4 37.7308 15.3371 20.9125 -24.2604 -24.0664 4.77074 +8685 6 20.8464 4.94114 21.1044 31.4042 5.97012 13.2179 +8686 4 20.3644 5.60924 21.5958 -5.50293 4.43366 -4.7096 +8687 4 21.773 5.03668 21.4416 -23.5272 -13.3128 -11.683 +8688 6 36.7544 1.79945 7.61694 -30.3574 47.6061 45.3867 +8689 4 36.327 2.6686 7.87118 16.8784 -26.1974 -29.8241 +8690 4 36.8428 1.50799 8.53455 15.1793 -22.3797 -11.8231 +8691 6 12.2439 31.5023 37.4569 -32.4985 -2.96535 6.06153 +8692 4 12.7586 31.1596 36.7365 10.4364 1.05198 -9.11954 +8693 4 11.3919 31.0227 37.3953 11.2973 8.58078 9.3944 +8694 6 38.9908 41.586 16.881 -5.73716 8.1645 -10.5856 +8695 4 39.3046 41.7073 15.9766 4.30886 -9.33368 3.06156 +8696 4 39.3667 0.405687 17.3669 3.77504 10.3777 9.96207 +8697 6 31.8904 27.2678 22.2602 -2.97266 4.85738 -46.2508 +8698 4 31.2122 26.6002 22.3915 1.88455 0.488126 10.0993 +8699 4 31.7489 27.4981 21.2895 3.71213 -3.79941 38.8104 +8700 6 42.7405 9.18554 25.589 -22.1194 -12.6454 -9.25487 +8701 4 42.0872 8.82691 24.9599 0.650449 1.17306 7.26361 +8702 4 43.4011 9.54846 25.0154 21.3216 10.0262 -4.62936 +8703 6 50.9383 28.1736 25.3544 -13.6318 0.0171378 28.1732 +8704 4 50.4953 27.5553 24.7803 -5.9639 1.72187 -15.2616 +8705 4 50.5272 27.9992 26.2251 14.2447 5.57945 -12.3971 +8706 6 43.1888 19.6578 30.9105 -66.6531 23.7889 25.5358 +8707 4 44.0873 19.829 30.8982 70.1332 9.75906 -5.84371 +8708 4 42.7965 20.4661 31.3425 9.97757 -17.7871 -10.1322 +8709 6 30.6644 14.0457 40.7997 -18.1309 16.7334 54.243 +8710 4 30.3214 14.3504 41.7092 15.0959 -2.90855 -40.5845 +8711 4 30.1739 13.231 40.7145 -1.19418 -16.8866 -12.4659 +8712 6 20.9131 15.4897 23.0235 5.61878 12.7036 12.8066 +8713 4 20.368 16.1905 23.4302 1.66694 -9.32372 -6.67403 +8714 4 21.8218 15.751 23.2692 -7.37195 -9.57776 -6.18749 +8715 6 34.2171 0.764056 35.8253 8.40959 -35.3498 44.9304 +8716 4 34.6567 1.46863 36.3417 -5.08936 -9.30099 -7.81199 +8717 4 34.1194 41.866 36.4755 2.29033 39.9746 -37.3302 +8718 6 38.9162 36.9098 35.9203 10.0793 6.80115 3.36275 +8719 4 39.7784 37.1612 36.3284 -16.0364 -11.2649 -5.21842 +8720 4 38.6132 36.0588 36.2696 9.66804 2.35098 0.533126 +8721 6 45.1336 25.2146 22.7744 -28.8992 3.863 21.2581 +8722 4 44.1561 25.0943 22.7165 17.1243 8.87651 18.653 +8723 4 45.3983 24.7563 22.0047 17.0602 -12.3694 -29.5411 +8724 6 40.597 0.8134 35.9421 3.227 69.6319 -3.88491 +8725 4 40.5509 41.8059 36.0096 -6.03355 -53.2669 -4.53187 +8726 4 39.9427 1.13471 35.2813 10.0151 -17.6297 16.5691 +8727 6 11.0455 28.3465 35.0235 9.7668 1.71998 -0.601403 +8728 4 10.9819 27.7367 35.7737 -0.960779 4.073 1.47136 +8729 4 10.3922 29.0422 35.1677 -11.8786 -4.48184 3.12795 +8730 6 20.2051 13.5934 35.8566 39.7213 -43.4527 45.4399 +8731 4 19.4813 14.0017 35.4777 -48.9883 30.031 -35.164 +8732 4 20.9868 14.0394 35.5673 14.4182 15.1 -18.5178 +8733 6 39.6245 5.13776 1.76997 -0.951619 9.89005 21.073 +8734 4 38.8252 4.77089 1.41386 -14.9185 -6.12031 -3.7056 +8735 4 40.3018 4.93211 1.13633 15.4903 5.30459 -14.5773 +8736 6 30.2698 30.8736 32.4375 -6.71798 15.6036 14.0469 +8737 4 29.6901 31.1438 33.1751 5.76607 1.99955 -8.25679 +8738 4 29.7896 30.1731 32.0039 1.14172 -17.9152 -6.50707 +8739 6 14.5598 11.0088 22.8703 10.5759 -0.53797 13.7125 +8740 4 15.2344 11.6195 23.3114 -32.0235 -23.0075 -11.5695 +8741 4 13.848 10.7777 23.5118 19.1574 10.2796 -1.34673 +8742 6 20.7379 13.9443 3.00881 5.16887 -45.0314 -26.4616 +8743 4 19.9261 13.6658 2.50706 22.866 18.233 23.793 +8744 4 20.5244 14.6819 3.55007 -16.1173 25.3417 12.2311 +8745 6 41.3029 4.28468 12.6203 -8.04128 10.917 21.7417 +8746 4 40.6152 3.63858 12.7642 -6.82471 -4.23516 2.09603 +8747 4 41.6484 4.11485 11.7651 11.719 -9.67534 -28.974 +8748 6 10.8581 24.7328 21.7161 -39.3585 -15.8792 -33.4515 +8749 4 10.0068 24.8598 21.1989 28.1112 14.2693 20.1969 +8750 4 11.1639 23.9123 21.3137 10.3572 -6.50453 7.69671 +8751 6 53.5762 20.8825 34.3773 -29.6915 -0.0415475 -3.94304 +8752 4 54.5085 20.795 34.3185 33.8519 4.29786 -2.30511 +8753 4 53.2552 20.0612 34.7861 8.83511 12.9473 -9.59804 +8754 6 14.8838 4.84499 30.449 -1.65326 0.839716 -13.8987 +8755 4 14.8578 5.00753 29.4799 -4.93385 -7.75961 17.951 +8756 4 14.5437 3.94124 30.5804 2.28716 7.27432 -2.63088 +8757 6 48.9137 37.1159 13.1232 -44.1315 32.6594 -31.0851 +8758 4 47.9268 37.1149 13.1949 24.5681 4.85746 10.1076 +8759 4 49.2024 36.4546 13.7037 17.9017 -30.2536 24.0784 +8760 6 26.8017 19.3068 7.5379 -15.1037 -1.6612 14.6377 +8761 4 27.3245 18.5243 7.34583 -2.01051 -6.65035 -9.19035 +8762 4 27.3053 20.0577 7.2492 18.4232 10.5976 -10.0514 +8763 6 17.631 11.9383 39.0904 -43.3265 13.8677 10.122 +8764 4 18.4941 11.6307 38.9203 38.4816 -13.6738 2.54756 +8765 4 17.5009 12.0978 40.0481 6.31677 -1.58465 -10.4285 +8766 6 49.9233 14.5931 8.61354 5.83785 -36.2985 -8.08798 +8767 4 49.214 13.9285 8.60404 6.89175 6.08198 5.75816 +8768 4 49.5175 15.3796 8.93642 -5.42274 33.9852 6.11405 +8769 6 32.3642 34.9667 31.5078 2.95354 23.7899 20.5819 +8770 4 32.072 34.4222 30.8036 -4.84614 -18.7532 -16.6478 +8771 4 32.4643 35.8463 31.1217 -0.970967 -0.757054 5.3462 +8772 6 11.8286 22.2266 21.3061 -17.2258 -15.6378 -41.9552 +8773 4 12.2171 21.6669 20.5638 -11.8041 19.7065 26.8676 +8774 4 12.3859 22.1258 22.0497 29.6948 -3.02551 21.8379 +8775 6 33.8509 9.96106 13.6416 -14.3875 -24.3714 -53.1057 +8776 4 33.0123 9.50508 13.4028 8.15621 17.9807 22.2309 +8777 4 34.3201 9.78154 12.7883 7.50726 12.1846 28.7729 +8778 6 25.5192 36.3946 1.51103 -10.4602 3.19395 -11.4439 +8779 4 26.0842 36.7323 0.810141 8.62195 6.50952 5.56913 +8780 4 24.6933 36.9065 1.40961 6.72848 -10.059 1.65156 +8781 6 26.2721 10.5411 9.76409 -19.2005 -4.19702 2.88354 +8782 4 25.6096 11.193 9.42675 5.9346 -6.99241 18.1855 +8783 4 25.839 9.94226 10.4354 7.43867 25.8511 -14.7334 +8784 6 25.016 0.794303 40.8954 13.3669 6.17095 4.00755 +8785 4 25.3682 0.342397 40.1084 -6.19889 9.04785 1.09472 +8786 4 25.4075 1.69244 40.9338 -2.19893 -14.7289 -5.24662 +8787 6 46.2434 3.93626 24.8203 6.94819 -22.6825 -8.03363 +8788 4 46.3834 4.04208 23.8743 3.61713 6.01616 -2.12387 +8789 4 46.2394 2.96647 24.9181 -8.37252 7.22853 3.62774 +8790 6 21.5889 13.6037 29.2057 4.95103 8.76674 17.4208 +8791 4 21.6019 14.3052 29.8879 -2.51331 -9.966 -5.68557 +8792 4 21.3126 14.082 28.4253 -2.16645 0.501775 -6.52993 +8793 6 36.7737 38.3803 0.360926 -13.0762 -25.442 -6.6792 +8794 4 36.4499 39.0355 0.978203 -4.80976 12.188 0.88021 +8795 4 36.0266 37.7487 0.22189 15.835 12.8395 4.19355 +8796 6 19.3086 17.6338 24.0617 47.0109 35.6134 -17.5995 +8797 4 18.4263 17.3722 24.1632 -50.3154 -15.1751 2.93786 +8798 4 19.3137 18.3511 23.365 -2.62926 -22.9616 14.087 +8799 6 23.1803 12.6945 3.50697 -12.4047 4.12184 -0.296296 +8800 4 22.2521 12.9621 3.30307 10.5621 -3.58256 -0.535563 +8801 4 23.3663 11.8631 3.0578 -9.23841 -1.30096 -1.53094 +8802 6 37.8891 8.88353 35.4651 -18.9945 -25.3999 -47.3866 +8803 4 38.8166 8.83127 35.1934 2.77199 2.98421 7.2207 +8804 4 37.4068 8.32521 34.752 23.9265 29.6152 37.0755 +8805 6 14.3237 15.1253 36.1844 10.7536 -1.62675 -12.1114 +8806 4 15.0418 15.7291 36.3902 7.37284 -3.65767 0.0646607 +8807 4 13.765 15.154 36.9379 -17.7819 2.51157 18.8211 +8808 6 35.0801 0.941274 33.018 -10.8249 30.7834 33.3167 +8809 4 34.9269 1.883 33.2395 6.71896 -7.58638 -28.1375 +8810 4 34.9733 0.615676 33.9226 0.339269 -19.4543 -11.259 +8811 6 50.9271 0.518298 17.9933 -4.01299 -8.33658 -1.61011 +8812 4 50.7551 1.39133 17.5891 -0.713529 -12.5397 8.99793 +8813 4 50.17 41.8323 17.8017 14.8721 13.6567 -6.57092 +8814 6 26.2328 30.5636 0.934374 -8.95911 39.2037 50.9017 +8815 4 26.9657 31.1139 1.27364 -12.5333 -13.1029 -5.86431 +8816 4 26.5352 30.0815 0.207089 19.4446 -20.9762 -37.1203 +8817 6 18.5681 38.3031 4.5613 16.0408 -0.4472 -12.493 +8818 4 17.6336 38.3732 4.40187 -16.7548 5.85511 1.82222 +8819 4 18.9561 38.7121 3.75593 -0.616515 -6.35836 15.3023 +8820 6 31.1349 5.07457 4.1166 35.5071 -12.4218 -11.0008 +8821 4 31.9258 4.61163 4.53765 -37.2933 13.7034 -13.5003 +8822 4 31.2792 5.02565 3.1391 -9.10044 -1.2591 17.9933 +8823 6 26.4378 21.892 1.49191 0.117022 -23.7737 9.75083 +8824 4 26.3504 22.7277 1.07049 4.38069 30.3527 -12.7348 +8825 4 27.3618 21.6023 1.50897 -0.762137 4.81239 -9.09803 +8826 6 39.2154 11.7026 22.7855 15.1366 1.14561 24.1899 +8827 4 39.8619 11.6546 23.5153 -3.42244 7.72178 -8.31759 +8828 4 38.7922 10.855 22.8508 -11.0077 -10.6036 -7.38167 +8829 6 13.6049 36.3215 30.6697 16.8779 70.0034 -37.8159 +8830 4 13.9417 37.1302 31.1268 -10.116 -30.1168 -5.71441 +8831 4 13.4922 35.6039 31.2515 -3.36872 -19.2676 30.0327 +8832 6 50.5831 9.86782 9.34675 -39.9446 -18.2052 0.719337 +8833 4 49.679 9.5553 9.65542 27.7691 6.62521 -8.8993 +8834 4 50.7343 10.6656 9.84378 7.47556 12.1458 9.31829 +8835 6 49.6659 40.3022 22.5839 -5.95569 -23.2057 2.00246 +8836 4 49.9088 39.3695 22.3976 1.04597 17.1639 -6.42107 +8837 4 49.3089 40.2511 23.4853 9.00681 3.37443 -0.55643 +8838 6 7.21026 41.318 28.8937 -13.882 28.5523 32.2899 +8839 4 7.13277 41.6426 29.851 5.74914 -19.7174 -37.6289 +8840 4 7.14599 0.215754 28.3517 11.7183 -8.26627 3.5395 +8841 6 13.0317 18.008 25.3351 57.1177 45.3919 41.6622 +8842 4 13.702 18.0765 24.6297 -18.9881 -2.87884 -2.05071 +8843 4 13.5608 18.5052 26.1022 -41.5403 -41.2906 -37.5185 +8844 6 50.0508 19.5822 2.43378 8.05757 -12.3534 -25.4868 +8845 4 50.6415 19.2321 1.70522 -9.91294 15.3245 28.3035 +8846 4 50.4964 20.3068 2.88656 9.48594 2.0046 -2.18375 +8847 6 28.3417 40.9623 24.5247 28.1527 -9.28969 -2.11238 +8848 4 28.8808 40.6229 23.7869 -8.53201 1.00989 5.926 +8849 4 27.851 41.6822 24.1702 -24.0642 17.3603 -12.6153 +8850 6 19.4173 5.36544 29.5282 -16.7292 -1.42659 17.4998 +8851 4 20.0576 6.03033 29.2802 12.6037 1.87093 -5.71578 +8852 4 18.8017 5.84191 30.1159 0.735032 -8.12986 -7.95209 +8853 6 35.3107 40.1454 22.2712 -2.40765 19.7984 -7.699 +8854 4 35.7006 39.9699 23.1142 6.54418 -16.9762 14.0951 +8855 4 35.2702 41.1078 22.294 -0.592679 0.794763 -5.20647 +8856 6 16.1889 33.7724 9.7458 10.3229 10.2088 29.582 +8857 4 15.8959 33.2543 9.01299 -6.07516 -13.8809 -16.7379 +8858 4 15.6715 34.5759 9.82028 -7.73583 2.776 -7.11592 +8859 6 17.3675 40.6445 20.2267 0.0256395 24.2963 -9.09373 +8860 4 17.2094 39.7816 20.6122 1.5629 -5.58702 6.23448 +8861 4 17.4758 41.3298 20.9152 1.51783 -13.2527 0.49298 +8862 6 20.5171 9.72867 9.58726 35.059 7.05341 -25.1666 +8863 4 21.2226 9.96362 10.213 -13.2653 -0.810893 -5.91795 +8864 4 19.8248 9.38464 10.113 -26.7953 -13.816 19.6743 +8865 6 47.4426 20.1922 21.3765 55.2231 -18.8128 34.629 +8866 4 48.295 19.6294 21.3384 -41.3243 22.9169 -3.74061 +8867 4 46.9816 20.0754 20.5659 -14.9725 -5.50706 -31.0177 +8868 6 38.4071 40.79 37.8146 12.3234 -22.6201 -9.80787 +8869 4 38.1404 41.7017 37.8605 -3.64711 23.1989 -4.06141 +8870 4 38.2696 40.4362 38.6954 -10.1247 -0.131598 9.15413 +8871 6 4.78578 1.94641 13.1038 0.280311 5.55092 -8.42179 +8872 4 4.79931 1.2475 12.4246 2.88607 5.75183 11.0778 +8873 4 4.58324 1.57529 13.9639 -2.31824 -10.9024 4.61034 +8874 6 46.8249 29.0091 2.16845 3.76482 2.94797 40.2579 +8875 4 46.7332 29.1215 3.14399 -15.0191 0.321828 -28.5005 +8876 4 47.6691 28.5689 2.15078 10.7116 -9.65214 -17.1948 +8877 6 37.4359 26.1653 25.6478 9.30824 1.4869 -5.75173 +8878 4 37.1837 25.5346 26.3178 -5.80587 -7.25577 3.90549 +8879 4 36.6384 26.5534 25.3025 -7.59782 4.42715 -0.0787482 +8880 6 27.3269 4.19583 19.442 5.96538 17.8772 -24.7701 +8881 4 28.0114 4.58146 18.8428 -3.77368 -14.8915 15.8068 +8882 4 26.5277 4.61529 19.0816 -6.14884 -6.84507 9.70558 +8883 6 29.57 35.1706 32.6629 9.65469 -19.4491 -13.9626 +8884 4 29.5306 34.4116 32.0191 -0.1659 24.8691 21.1709 +8885 4 30.4743 35.5004 32.5856 -0.51053 -0.290213 -2.43375 +8886 6 51.6097 27.3863 34.6091 -31.2455 30.913 9.06642 +8887 4 51.929 26.6019 35 16.42 -40.5282 7.55135 +8888 4 52.0725 27.582 33.8009 7.9649 -1.59603 -13.3915 +8889 6 26.2078 15.7281 22.6941 16.538 -21.7488 31.7554 +8890 4 25.9667 16.5615 22.3191 -8.70869 23.0893 -12.8942 +8891 4 26.0629 14.9994 22.0993 -9.54979 -3.97748 -17.7982 +8892 6 36.1239 41.1986 15.4707 -7.45359 -19.8962 -4.3143 +8893 4 35.6999 40.3419 15.2987 -9.47391 11.3121 -0.409552 +8894 4 37.0386 40.9374 15.4513 15.7433 3.85103 -0.545832 +8895 6 18.465 8.81345 11.2165 5.38391 10.0618 1.17025 +8896 4 18.7987 8.15135 11.8182 8.53154 -1.35082 11.1952 +8897 4 17.7161 8.38168 10.8393 -16.7411 -2.38381 -11.2186 +8898 6 30.2088 21.3096 23.2049 -11.6688 7.62645 -9.73036 +8899 4 29.9671 22.1993 22.9248 4.97058 -0.914249 3.78278 +8900 4 29.5299 20.7541 22.7893 7.94877 -1.13118 2.47612 +8901 6 22.73 2.20521 34.8374 1.74432 -25.8699 49.3747 +8902 4 22.3572 1.29354 34.8889 6.16039 22.5731 -10.8251 +8903 4 22.7018 2.4887 33.9486 -6.75325 10.5307 -40.1895 +8904 6 12.6909 2.75059 12.3422 -14.3125 16.3183 -13.6311 +8905 4 12.533 3.61796 11.8786 11.7453 -23.2619 14.9881 +8906 4 13.1336 2.19907 11.6816 1.83842 1.45343 3.2847 +8907 6 24.107 30.0639 14.5719 -73.5796 11.8292 4.65098 +8908 4 23.699 30.7611 15.1345 32.1371 -0.343623 -0.31889 +8909 4 23.2337 29.7156 14.2286 43.085 -3.68866 -7.89372 +8910 6 0.015177 27.9048 22.8533 -2.756 -4.53229 -2.63487 +8911 4 54.6492 28.3778 23.623 -8.36257 -3.01834 -6.1652 +8912 4 54.216 27.6514 22.3224 8.23112 8.70814 10.2495 +8913 6 12.3617 4.4844 25.9108 40.9735 -25.7794 -17.3291 +8914 4 12.201 5.40791 25.8162 -22.6464 21.2272 1.21762 +8915 4 11.6198 4.00067 26.267 -15.5784 4.93476 10.9426 +8916 6 50.6578 14.4652 5.91353 -13.9437 -6.30553 43.3918 +8917 4 51.4397 15.014 5.76935 2.55266 2.90763 -3.8133 +8918 4 50.4787 14.4827 6.92851 9.15248 3.54798 -49.9389 +8919 6 52.5668 22.873 20.1428 -12.6564 -29.9263 -28.8801 +8920 4 52.956 23.3393 20.8718 4.45243 13.9606 14.107 +8921 4 52.7899 23.3428 19.3246 -0.129831 10.341 11.583 +8922 6 43.5892 16.524 12.8775 29.595 -3.78245 -19.1347 +8923 4 44.3058 16.0087 12.3806 -28.6005 27.9094 23.6723 +8924 4 42.7982 16.4888 12.3437 -11.2315 -8.54457 -10.2035 +8925 6 15.9661 16.7487 40.5866 1.44034 32.7745 -1.20572 +8926 4 16.4126 17.3388 39.9207 -12.1014 -18.8104 17.452 +8927 4 15.5985 17.3766 41.2587 12.5036 -14.614 -16.5617 +8928 6 23.4158 18.8712 23.8473 -16.0774 -11.4939 3.2157 +8929 4 23.4518 19.2692 24.728 -0.157295 3.62127 -3.85719 +8930 4 22.4941 18.9757 23.5436 12.0607 -0.266031 2.57498 +8931 6 46.4178 3.27548 31.8952 19.5415 -1.29071 -17.2416 +8932 4 45.5866 3.26999 31.4067 -8.61336 -0.166695 4.01481 +8933 4 46.2657 3.3297 32.8359 -5.35267 1.32166 2.09612 +8934 6 43.4045 41.0584 12.2875 -8.04746 -23.5947 4.76735 +8935 4 43.6693 41.8276 12.7696 6.05224 12.9314 10.8988 +8936 4 43.5172 41.2728 11.3626 0.904796 3.93503 -13.2342 +8937 6 7.4976 32.4756 29.5884 -13.7893 55.6862 -12.0377 +8938 4 8.07142 31.7837 29.8334 27.4303 -26.9633 6.13269 +8939 4 8.04212 33.3166 29.512 -13.0153 -27.2422 -1.65156 +8940 6 4.77821 31.644 22.4997 2.28771 28.4048 16.4959 +8941 4 5.27411 32.2412 23.0928 2.56389 -13.4484 -8.63656 +8942 4 4.12057 32.2584 22.1518 -1.39427 -10.0394 -7.16978 +8943 6 48.879 26.8662 2.67919 -5.86075 -60.7959 24.9619 +8944 4 49.7001 26.7095 3.23946 -26.2991 7.4186 -32.0291 +8945 4 48.3448 25.9902 2.75892 28.4546 51.6452 -6.88552 +8946 6 35.3626 23.261 21.6242 -2.7789 -2.57103 6.54281 +8947 4 36.2261 22.8974 21.81 4.94258 -15.6751 6.88864 +8948 4 35.5426 23.9136 20.9639 -1.02428 17.548 -23.8062 +8949 6 9.79934 37.7758 27.3048 16.52 16.637 17.9603 +8950 4 9.72643 38.6113 27.803 -16.1555 -8.36248 -12.7831 +8951 4 10.5885 37.4189 27.7206 -2.15823 -16.4776 -5.60851 +8952 6 6.95685 10.9812 25.9821 -25.178 -21.2877 -4.97438 +8953 4 6.33357 10.2528 25.7268 23.179 21.9129 0.503821 +8954 4 7.29095 10.6974 26.8328 9.60603 -1.481 14.6966 +8955 6 15.9965 34.4888 38.9273 -2.91878 -3.91161 19.3063 +8956 4 16.0374 33.5463 38.7461 4.95306 -0.665665 -16.4822 +8957 4 15.9715 34.4958 39.9054 -7.59103 5.72172 -22.2107 +8958 6 24.1167 17.3197 36.1615 15.3363 -47.5124 0.380375 +8959 4 24.7173 17.5753 36.8648 1.58194 5.49031 12.5141 +8960 4 24.1546 16.3101 36.2205 -9.7187 30.8811 -7.11116 +8961 6 29.9757 19.0472 5.63639 12.788 -31.6225 11.2379 +8962 4 30.1584 18.5328 6.46799 -12.7316 12.501 -21.5451 +8963 4 29.4206 19.7916 5.84051 -11.4929 16.6696 15.0892 +8964 6 41.2293 14.2018 25.873 -1.75888 28.9255 -23.3251 +8965 4 41.1078 15.0995 25.4693 3.83492 -22.0907 13.098 +8966 4 41.2654 14.3268 26.8215 3.7207 5.50516 9.94654 +8967 6 30.6006 17.7874 37.3562 -24.7598 46.8721 10.074 +8968 4 30.0173 18.4181 36.8416 23.2796 -25.9316 -1.25214 +8969 4 30.633 18.2764 38.2118 8.15578 -14.795 -8.30511 +8970 6 36.2662 35.7599 28.8527 -12.8707 -30.9202 21.2821 +8971 4 36.6718 34.9534 29.2396 -10.1595 12.442 -4.1956 +8972 4 37.0218 36.2801 28.6478 17.3511 22.2532 -11.5483 +8973 6 0.195836 37.8645 20.3851 -23.6217 6.21569 -13.9532 +8974 4 0.549498 37.2778 21.0637 4.94615 -2.95215 -2.70832 +8975 4 54.3862 37.4234 20.0075 16.4722 8.11718 6.90773 +8976 6 49.5165 39.5896 25.2714 -0.622408 -34.3922 32.9891 +8977 4 49.1772 39.7667 26.1925 10.9208 -1.11318 -32.3029 +8978 4 49.8261 38.6352 25.2806 -10.9036 35.658 1.81375 +8979 6 21.6574 10.1952 29.3538 -5.06277 -0.743802 10.2318 +8980 4 21.4664 11.1105 29.223 -3.01111 19.5458 -20.3057 +8981 4 21.662 10.2064 30.3052 9.73006 -17.7161 13.8831 +8982 6 36.4636 30.0567 0.119709 9.37859 61.6807 38.5429 +8983 4 36.3123 29.4684 41.3206 -1.21017 -23.1836 -37.505 +8984 4 36.9143 30.908 41.7057 -13.4567 -39.5067 4.20368 +8985 6 35.2344 23.3726 39.1433 31.8417 -88.9919 -51.9106 +8986 4 35.0278 23.5012 38.2069 -5.96056 -5.38998 8.96032 +8987 4 34.9909 24.127 39.538 -31.8308 96.9265 45.0865 +8988 6 25.4761 17.6258 38.7257 1.29934 8.28965 -16.1346 +8989 4 26.2031 17.0769 39.0234 13.7946 -6.33455 1.86524 +8990 4 25.7107 18.4933 39.0598 1.3782 7.33891 4.86011 +8991 6 32.6846 1.71002 15.3734 -11.6254 -20.3205 21.5399 +8992 4 32.9453 1.93093 16.3086 -8.96834 -8.53877 -20.2534 +8993 4 32.154 0.853232 15.3925 19.204 32.1949 4.36426 +8994 6 2.7574 26.2382 40.1716 -4.40087 -21.6692 -50.7652 +8995 4 2.38718 26.7949 40.8139 -8.13358 26.7101 38.7547 +8996 4 3.41358 25.6429 40.5298 13.0891 -5.49009 7.80053 +8997 6 25.4307 39.5752 6.64887 -26.4755 -1.32722 14.1102 +8998 4 25.8932 39.0809 7.30961 27.038 -6.17916 -3.25304 +8999 4 24.5458 39.4465 7.03066 -2.44587 12.932 -21.9634 +9000 6 3.88975 2.45855 21.1879 28.3389 -91.355 -25.6726 +9001 4 3.44478 1.54109 20.9736 25.4092 48.4753 9.01111 +9002 4 3.19228 2.99847 21.4284 -47.2055 43.8768 12.3888 +9003 6 19.4353 35.9908 6.17834 -1.98144 -11.1023 18.0698 +9004 4 18.7425 35.7628 6.83514 2.39623 12.5316 -16.1317 +9005 4 19.0828 36.5127 5.45195 -11.0597 11.4176 1.1294 +9006 6 53.664 10.8386 34.7899 -0.427116 -3.27611 41.7292 +9007 4 53.6105 10.6836 35.7561 -1.66612 -17.5448 -26.7849 +9008 4 53.9652 11.7272 34.8329 4.68725 29.9217 -18.2793 +9009 6 51.2799 14.0867 34.6651 -29.2798 -10.9719 -23.3019 +9010 4 50.6522 13.5411 34.1107 26.8684 18.9114 5.01949 +9011 4 50.9895 13.8814 35.5479 1.81167 -5.08277 17.6681 +9012 6 14.4338 40.0198 28.0288 -0.147098 23.5255 27.6002 +9013 4 13.7688 39.3521 27.8218 1.28331 -8.25373 7.75106 +9014 4 14.1948 40.5222 28.8704 -0.878391 -19.6822 -29.209 +9015 6 36.0552 40.8569 1.29319 48.4065 13.1893 15.2608 +9016 4 35.4421 41.0883 1.96787 -21.4185 -0.412662 13.5205 +9017 4 36.896 41.2683 1.66088 -27.5471 -12.7345 -18.5843 +9018 6 32.5846 21.8706 9.62772 14.4951 6.80277 0.680584 +9019 4 32.1936 21.3098 8.97285 -7.2875 -23.9506 -7.81502 +9020 4 32.858 22.6104 9.08324 0.955029 10.0343 1.40437 +9021 6 53.7602 11.4574 10.0748 -7.70253 -4.89045 -17.0247 +9022 4 54.6558 11.7035 10.3272 3.70339 -10.2166 -5.16833 +9023 4 53.8328 10.8374 9.31644 -2.27357 5.83713 13.9933 +9024 6 25.443 2.0669 35.0212 -16.7533 17.7231 -21.4763 +9025 4 25.6415 2.91576 34.5502 -7.64634 -16.7974 11.4347 +9026 4 24.4652 2.09352 35.1703 17.3945 -2.11295 -4.26167 +9027 6 38.4088 16.3775 27.0777 23.4896 -26.556 7.92078 +9028 4 38.4029 15.905 27.9411 -0.72651 18.7119 -5.4255 +9029 4 38.1233 17.2789 27.1678 -4.67214 15.3602 11.0072 +9030 6 11.9834 11.8283 38.0863 1.50515 -20.9897 -19.5245 +9031 4 12.337 12.445 38.7318 -5.05033 4.06408 7.46746 +9032 4 11.0493 11.6049 38.244 7.06215 11.5652 6.68382 +9033 6 21.1646 40.7247 25.8949 30.8575 -6.32012 -20.5276 +9034 4 20.7152 41.4784 25.5554 -14.4662 20.9939 -18.0031 +9035 4 20.8194 40.6451 26.758 -13.9443 -15.9826 36.5019 +9036 6 5.45737 31.2526 28.1092 12.1805 15.5126 -2.48606 +9037 4 4.77986 31.7446 27.6301 0.776808 -0.764161 -8.53258 +9038 4 6.21204 31.8695 28.2031 -7.61365 -6.18966 7.74582 +9039 6 38.5666 10.4345 26.6322 12.4833 -8.23035 1.5222 +9040 4 39.2815 10.9281 26.2104 -2.91177 1.8082 -0.00903947 +9041 4 39.0293 9.89744 27.2937 -7.88948 5.75886 -1.98766 +9042 6 34.5704 22.2441 5.77364 -5.35359 -6.12765 6.5276 +9043 4 33.6261 22.329 6.01336 10.9983 8.59631 1.2651 +9044 4 35.1361 22.6291 6.46875 -10.1328 -5.43064 -4.61746 +9045 6 19.508 23.4157 8.91293 -5.78488 4.73981 5.04963 +9046 4 19.7274 23.1974 9.83518 1.16663 -6.94775 -9.92836 +9047 4 19.9131 22.8043 8.29809 9.12387 -6.1547 2.91491 +9048 6 19.7424 39.1606 18.9462 6.36032 12.2479 8.14591 +9049 4 20.3561 39.0422 19.6872 -3.85164 -4.35394 -5.20149 +9050 4 19.0738 39.7495 19.3414 -1.06489 -8.07777 -11.9442 +9051 6 19.0057 16.6591 37.8853 37.3334 -16.7993 4.17439 +9052 4 18.1861 16.4809 37.4823 -32.8062 -2.38488 -19.1553 +9053 4 18.8146 17.2984 38.5514 -2.10283 15.4454 14.1988 +9054 6 46.1541 18.3125 34.4675 -16.9871 7.29415 15.254 +9055 4 46.1595 17.7325 33.7168 0.615393 -10.1859 -17.2384 +9056 4 45.2376 18.6499 34.5058 9.28079 -5.03019 -2.85447 +9057 6 37.6537 4.93165 10.635 20.1552 -8.04423 -16.7256 +9058 4 38.5399 5.21744 10.272 -26.6503 -7.30776 7.98139 +9059 4 37.1074 4.55852 9.88971 22.9932 21.6332 27.1334 +9060 6 51.9792 36.004 6.8478 30.791 3.18545 -0.726681 +9061 4 52.2413 36.7963 6.35992 -14.9215 -4.55469 -2.53046 +9062 4 52.8266 35.8818 7.33626 -22.3254 6.63746 5.40006 +9063 6 26.6741 12.3268 1.0034 -10.7024 -25.4666 -34.2692 +9064 4 26.4988 12.3574 1.94138 -4.81655 1.43394 14.8604 +9065 4 26.0954 11.585 0.663483 16.9242 17.5219 15.4646 +9066 6 51.3423 35.7724 13.5298 -0.266216 29.5034 10.6004 +9067 4 51.4043 36.4131 12.804 2.34884 -4.4098 -1.45811 +9068 4 51.4073 34.9167 13.1542 5.41074 -27.2154 -15.541 +9069 6 1.98873 3.64285 24.5869 25.9971 69.8048 -55.2188 +9070 4 1.65752 3.03018 25.1632 -30.3002 -46.9535 54.3289 +9071 4 1.71436 4.54846 24.8879 2.6309 -26.2008 -0.982747 +9072 6 33.5221 15.2795 16.4506 0.0536135 -15.838 -38.1617 +9073 4 33.6476 15.3964 15.4593 -8.63578 3.82522 35.1416 +9074 4 33.7341 16.1085 16.8736 8.85342 14.4801 4.37501 +9075 6 10.7227 26.5775 37.3442 -67.903 54.2831 -20.645 +9076 4 10.2191 27.0779 38.0369 14.5194 -13.2702 -3.80745 +9077 4 11.4784 26.2608 37.7268 68.0232 -30.094 41.6962 +9078 6 39.6271 8.38119 31.999 1.44949 -5.13238 35.1009 +9079 4 39.1996 8.85287 32.7464 5.61163 -5.5592 -21.3265 +9080 4 39.0885 8.45634 31.2221 -15.3514 9.3045 -12.0182 +9081 6 48.873 24.2439 11.5987 1.10357 -37.2725 -9.21005 +9082 4 49.1825 23.3167 11.4023 -5.65288 27.9965 8.32055 +9083 4 49.5986 24.6511 12.0826 3.19491 3.15896 -2.50749 +9084 6 15.8098 8.51994 22.5326 -12.5814 0.672941 2.19285 +9085 4 15.7588 8.52265 21.5683 10.3815 2.49136 4.36748 +9086 4 15.4206 9.36801 22.7863 6.5895 4.65597 -0.371293 +9087 6 16.9392 23.5364 7.95083 25.1749 21.5498 -34.0775 +9088 4 17.2079 23.9031 7.093 -25.8979 -5.01679 3.50755 +9089 4 17.8126 23.4623 8.29573 16.7216 -7.09478 32.6865 +9090 6 42.4825 26.8555 6.33102 0.60087 7.54144 -12.7632 +9091 4 41.764 27.4892 6.46083 9.75026 1.01062 3.5184 +9092 4 43.14 27.3488 5.78659 -9.42643 -3.33158 7.6404 +9093 6 36.8078 4.79995 30.0438 -4.74249 18.2042 -3.85385 +9094 4 36.952 4.89746 30.9922 3.10706 -1.8894 0.559973 +9095 4 36.294 4.02131 29.8808 -10.4691 -15.4659 3.71438 +9096 6 45.6128 11.6142 3.31163 15.5246 21.1623 13.6733 +9097 4 45.8972 10.701 3.31117 0.727629 -14.3179 7.30305 +9098 4 46.2501 12.0834 3.90994 -13.3278 -10.7206 -15.6492 +9099 6 24.8943 36.3842 21.2731 0.145584 -0.0155718 21.9832 +9100 4 24.5073 36.3627 22.1568 -5.92138 3.86098 -2.91089 +9101 4 25.79 36.6624 21.4916 7.30899 1.2523 -13.3669 +9102 6 31.8172 24.7218 2.44079 24.9542 32.077 -0.738567 +9103 4 31.5948 23.8911 2.82575 -7.26237 -24.1795 3.52598 +9104 4 32.7966 24.7848 2.51706 -20.2581 -1.29655 -5.98664 +9105 6 24.135 21.9795 37.225 -18.6422 57.7065 19.5247 +9106 4 24.1223 22.9841 37.1061 1.06209 -41.2434 9.50937 +9107 4 24.7129 21.6948 36.5371 13.1815 -12.7877 -24.1492 +9108 6 37.1979 11.5342 15.06 20.8972 -17.7328 -40.5152 +9109 4 38.0246 11.7972 15.4709 -1.33045 5.21986 19.7962 +9110 4 36.429 11.9138 15.4438 -18.178 22.6449 25.793 +9111 6 36.4751 20.3399 41.7845 -26.5497 -48.0551 41.2862 +9112 4 36.3228 19.4621 41.3748 1.60744 11.8178 -3.29004 +9113 4 36.9246 20.873 41.191 27.5593 28.4699 -43.2619 +9114 6 32.0497 37.9214 32.6612 -32.2386 -8.50634 -18.7459 +9115 4 32.4337 38.7163 32.9803 20.8647 20.5609 12.2985 +9116 4 31.3654 38.2694 32.0613 5.31663 -14.2519 5.69849 +9117 6 12.0395 39.928 22.5123 -26.9832 36.7812 23.3187 +9118 4 12.2839 40.8414 22.1926 -3.01474 -29.6796 4.86816 +9119 4 11.2932 40.0883 23.1662 29.524 -10.585 -25.0576 +9120 6 26.3406 1.33526 19.2893 15.6729 -20.8034 13.8388 +9121 4 26.8411 0.655996 19.8199 -14.5491 24.9752 -14.9066 +9122 4 26.8003 2.1813 19.3861 0.112049 0.00336314 -1.02908 +9123 6 5.91669 14.3164 5.69097 2.29729 -16.5161 -30.3395 +9124 4 6.30102 14.1024 4.7902 -6.32478 5.25084 23.5077 +9125 4 5.06552 13.8494 5.70115 7.33482 -6.30923 1.55114 +9126 6 13.3703 23.089 19.1627 -28.3895 15.3871 14.4757 +9127 4 14.1086 22.8122 18.6632 27.2898 -8.01563 -16.6587 +9128 4 13.6991 23.742 19.8005 3.67942 -13.964 0.879599 +9129 6 23.4058 15.0688 9.73621 -4.11719 1.06855 12.2005 +9130 4 22.5732 14.661 10.02 0.657405 4.9462 -7.25364 +9131 4 23.2196 15.7347 9.05868 -5.70535 0.38861 -5.0655 +9132 6 49.5812 13.8288 18.4474 0.101153 1.0527 41.008 +9133 4 48.8214 13.4814 17.9923 -8.96247 -7.71084 -15.1851 +9134 4 50.2052 14.1722 17.8367 10.7879 13.5653 -33.2962 +9135 6 41.7444 5.67096 41.8915 25.5819 0.859229 17.1787 +9136 4 42.5704 5.9364 0.475256 -21.6624 -6.74737 -14.5764 +9137 4 42.0361 4.9893 41.2645 -5.04703 6.59959 -2.77397 +9138 6 17.2492 35.5437 2.55512 -4.98919 17.2489 6.23124 +9139 4 18.1963 35.629 2.41282 7.59523 -3.20753 1.41995 +9140 4 16.9663 34.6563 2.38439 4.57262 -16.6324 -5.73806 +9141 6 49.6936 19.8647 40.242 36.1149 -8.05295 1.41344 +9142 4 49.24 19.0314 40.466 10.1916 2.45634 3.62304 +9143 4 50.6901 19.7225 40.3055 -34.6505 -2.12616 -4.55887 +9144 6 38.3055 5.83107 32.0437 -25.1209 3.13983 17.5072 +9145 4 37.8566 6.51058 32.5952 5.57321 -12.5864 -8.78808 +9146 4 39.2068 6.11217 32.0045 20.6085 6.27671 -1.8315 +9147 6 16.2656 6.85278 34.0134 13.6308 -7.44031 -0.955967 +9148 4 16.5278 6.7006 33.1016 -0.686465 1.61317 -6.98637 +9149 4 17.0706 6.57794 34.496 -11.7464 5.49098 9.02554 +9150 6 33.6779 18.1919 10.4599 39.833 -25.9405 -6.08719 +9151 4 34.2274 18.843 9.984 -7.48822 -11.4027 6.26591 +9152 4 34.2403 17.3374 10.5556 -30.6671 44.9369 -7.76686 +9153 6 38.8896 33.7563 36.7672 22.7659 10.9801 -36.8997 +9154 4 38.4264 33.5452 35.9055 8.66825 7.19978 21.2858 +9155 4 39.8358 34.0039 36.5278 -27.7603 -15.0244 3.77145 +9156 6 45.3747 13.0912 20.2115 -8.54575 18.1695 38.2532 +9157 4 45.1986 12.6554 19.3957 -4.2418 -14.8759 -23.2281 +9158 4 44.5273 13.1029 20.6991 7.89471 -4.73094 -13.0554 +9159 6 36.3919 32.2126 8.83938 1.15121 -2.28434 -1.4136 +9160 4 36.3207 31.3933 9.34391 1.93757 3.36082 7.91897 +9161 4 36.0586 32.9456 9.38554 -3.10773 -8.06217 -4.51958 +9162 6 7.93399 27.8164 6.18652 -8.84441 8.26416 -30.5327 +9163 4 8.20753 27.2416 6.88401 9.15323 -7.03573 14.7081 +9164 4 8.30192 28.6748 6.41842 -5.04409 0.971707 0.751098 +9165 6 14.2889 4.87494 33.6812 -48.074 -5.72289 -27.637 +9166 4 13.5426 5.15568 33.0467 38.2298 -5.02982 23.8683 +9167 4 14.8103 5.65434 33.8518 10.0815 16.0504 2.39638 +9168 6 12.247 8.64363 9.86387 9.5307 8.47707 -42.9656 +9169 4 12.7265 8.83196 10.6522 4.83417 -1.95201 32.3898 +9170 4 11.3733 8.28369 10.003 -7.27928 -7.56138 14.4849 +9171 6 29.7193 31.982 8.5339 -11.3757 5.45371 -22.6092 +9172 4 30.2272 31.7973 9.28681 18.5431 -1.21859 37.4341 +9173 4 29.7513 31.1489 8.05875 -9.95983 -0.182644 -6.87416 +9174 6 22.3912 10.8818 21.4749 22.6973 -30.3469 0.856054 +9175 4 21.7953 11.1177 20.7819 -19.5872 13.8984 -18.5017 +9176 4 22.3568 11.5583 22.1363 -13.7305 16.7548 8.89642 +9177 6 54.1825 27.5382 12.9949 16.0749 -34.873 29.2784 +9178 4 0.169556 27.5337 13.075 -9.84187 5.32432 -2.29215 +9179 4 53.8855 28.25 12.4714 -3.97587 36.1158 -26.3516 +9180 6 7.7322 13.8127 20.037 -51.4252 10.19 -38.2554 +9181 4 8.32211 14.101 20.6974 26.6579 16.8549 28.1402 +9182 4 7.28001 14.6396 19.6917 19.816 -24.9044 7.79538 +9183 6 19.8038 0.841082 24.7751 2.23798 25.7663 18.7115 +9184 4 19.2888 0.974936 25.5977 -1.44078 2.26272 -14.328 +9185 4 20.345 1.66892 24.688 -12.1486 -28.8133 2.35345 +9186 6 3.00622 10.0987 2.94957 -26.3714 23.4248 -9.90714 +9187 4 2.57802 10.9845 2.80681 8.85648 -28.8297 5.38 +9188 4 3.90714 10.2978 3.18407 20.8138 3.7803 5.2 +9189 6 15.8735 13.0135 24.0167 27.3456 -6.4848 -7.35342 +9190 4 15.0397 13.4574 24.067 -14.2007 12.8972 1.61729 +9191 4 16.3075 13.2711 24.8409 -0.511489 -7.63656 -0.0548578 +9192 6 17.0843 4.34635 26.9246 21.6007 -4.50946 14.2865 +9193 4 16.8972 4.2188 26.0046 2.50265 0.324122 -20.691 +9194 4 18.0611 4.2338 26.9976 -18.2314 5.96709 -0.11875 +9195 6 33.6189 39.4094 10.6341 -20.462 51.0085 -28.6484 +9196 4 33.9391 38.663 11.0702 20.9333 -51.253 8.17882 +9197 4 33.8334 39.409 9.67256 -1.15733 -4.02232 18.0774 +9198 6 36.2391 1.10544 13.1071 -14.4853 9.25302 -40.2412 +9199 4 35.5849 0.422507 13.2928 -0.138393 -8.38057 10.5121 +9200 4 36.8138 1.26142 13.8363 9.41155 -3.27129 23.8008 +9201 6 40.853 19.2974 5.10856 37.2457 -28.9827 71.4026 +9202 4 40.5429 19.587 4.3016 -40.6732 16.7295 -57.0845 +9203 4 40.1307 19.0416 5.7147 0.644924 10.2678 -10.4268 +9204 6 2.34714 37.5568 10.1845 35.9634 7.02123 17.8242 +9205 4 3.04769 37.1203 10.7322 -14.847 6.26565 -12.1612 +9206 4 1.86424 36.8893 9.71962 -14.8151 -24.6966 -11.8987 +9207 6 8.10127 29.0413 15.8656 35.302 -29.7249 12.8686 +9208 4 9.00843 28.6191 15.9508 -31.5464 15.4715 -14.0583 +9209 4 8.16404 29.7921 16.4466 -1.11054 13.1495 4.82257 +9210 6 47.3142 26.5199 12.5393 12.6514 34.6971 -22.5506 +9211 4 47.5805 27.2834 11.915 -17.373 -39.4708 28.4474 +9212 4 47.3752 25.7188 12.0092 -0.907674 -0.00416251 -5.94845 +9213 6 33.5917 17.5154 0.659811 -43.6991 -50.8046 22.4668 +9214 4 32.6165 17.4611 0.916402 33.9721 22.4374 -10.1482 +9215 4 33.8023 16.5556 0.790839 15.7196 25.0769 -8.55135 +9216 6 38.9785 15.6005 36.3846 -2.2974 -5.19358 -9.56289 +9217 4 39.1604 14.6481 36.4599 -0.972636 7.263 -3.41001 +9218 4 39.314 15.9159 35.5329 5.29716 -3.31476 -2.44888 +9219 6 34.8185 34.3512 9.36223 6.47638 -43.1481 -28.0847 +9220 4 35.4473 34.9875 9.0418 9.26483 22.2324 -9.2882 +9221 4 34.4241 34.6992 10.1221 -17.9819 29.7233 40.2724 +9222 6 44.963 2.56985 14.7807 31.4374 15.1132 5.36654 +9223 4 44.0324 2.49792 14.9225 -24.9873 -3.38313 6.1219 +9224 4 45.264 3.39221 15.2058 -8.16761 -2.00961 -7.57881 +9225 6 42.6004 38.2794 19.8329 35.0217 22.8895 -33.2683 +9226 4 42.7468 39.1886 19.4383 -9.39889 -30.5105 9.50416 +9227 4 43.174 37.7101 19.2395 -23.2435 10.9907 19.5876 +9228 6 18.6884 26.768 30.2631 -44.5574 -6.69712 -17.565 +9229 4 18.1049 26.7773 29.4546 19.8507 -1.43152 25.0232 +9230 4 19.5658 26.9377 29.9555 24.8572 5.14496 -8.76909 +9231 6 38.8622 37.7231 16.4658 -22.8479 4.5656 13.1257 +9232 4 38.7902 36.7734 16.2818 1.44729 8.74588 -1.32739 +9233 4 39.7766 37.9619 16.5567 26.2519 -3.67716 3.06508 +9234 6 49.2941 9.82087 12.5338 42.2108 35.2088 45.7943 +9235 4 48.9089 9.29765 11.888 -36.0338 -29.0733 -40.4243 +9236 4 48.6148 10.195 13.1058 -6.01968 0.395602 -5.44143 +9237 6 43.2224 7.37144 19.82 -8.13737 3.26926 23.5272 +9238 4 42.5007 7.77471 20.3735 21.5488 -7.79487 -11.5807 +9239 4 44.0862 7.49788 20.2643 -6.92785 0.102081 -4.68832 +9240 6 36.344 38.7219 4.42923 6.60518 -8.27287 -3.54737 +9241 4 36.8681 39.515 4.62823 -9.591 -1.38231 4.53716 +9242 4 35.4251 38.8858 4.67742 1.90858 4.69501 2.45497 +9243 6 27.7906 17.7903 15.1063 3.75124 -7.8529 -14.6222 +9244 4 27.6041 16.8818 14.7764 0.112743 20.8749 5.00331 +9245 4 27.89 17.7299 16.0573 -1.67078 -3.69001 6.73869 +9246 6 18.0934 3.7697 37.3166 -37.4896 -7.94699 -19.9181 +9247 4 18.6099 3.0373 36.9676 7.8944 1.98274 4.30106 +9248 4 18.6508 4.23334 37.9126 25.9725 10.5984 22.5053 +9249 6 7.70643 11.5866 6.5218 3.89219 -35.3855 26.5153 +9250 4 7.81247 12.3986 6.99593 -0.830342 19.7116 4.35361 +9251 4 7.69429 11.7375 5.59555 -1.18048 8.56411 -33.1609 +9252 6 31.493 14.3493 18.0362 -8.33789 -14.4781 24.6772 +9253 4 32.1359 14.6991 17.4236 11.1505 2.18599 -11.6706 +9254 4 31.9992 13.8221 18.6877 -1.72215 8.99473 -5.41338 +9255 6 50.3257 30.4119 8.91981 13.6638 2.66477 0.921327 +9256 4 49.6699 30.7962 8.33415 -6.09837 5.9585 -1.44957 +9257 4 50.0726 29.5063 9.09532 -3.6785 -2.74239 1.52637 +9258 6 42.1666 10.1001 12.7665 27.8846 0.568566 -7.78474 +9259 4 41.2574 9.89168 12.6212 -25.0269 -7.71108 -1.23548 +9260 4 42.2044 10.927 13.2385 -4.76175 6.29789 8.61568 +9261 6 37.7726 3.10257 32.5651 17.7286 -33.908 -11.3576 +9262 4 38.1655 3.96622 32.6549 -5.80606 19.6252 0.391082 +9263 4 36.8286 3.11418 32.7073 -14.5698 15.7581 5.48125 +9264 6 35.7529 13.1025 19.269 15.6222 -22.7979 5.95892 +9265 4 36.108 13.8438 19.7616 3.89933 6.86159 4.70877 +9266 4 36.3275 12.3403 19.5267 -16.9537 12.3267 -5.61016 +9267 6 45.5307 4.12701 21.4866 3.53751 -14.4086 10.8893 +9268 4 45.552 4.15257 20.5178 1.20389 1.85135 1.62688 +9269 4 45.7304 3.20168 21.7391 -1.66454 15.9633 -13.005 +9270 6 16.8818 1.84763 31.4809 -38.7514 34.7723 -17.791 +9271 4 16.1373 2.3559 31.0688 16.7124 -32.2776 -3.52377 +9272 4 16.9707 2.38347 32.2636 22.4894 -8.71684 18.7287 +9273 6 14.088 4.88632 23.5804 12.6338 -46.5447 -4.7054 +9274 4 13.8705 5.7909 23.7155 -14.7558 31.001 11.1078 +9275 4 13.7332 4.31383 24.2952 -4.17517 18.1368 -8.36436 +9276 6 38.3179 33.7515 12.3711 -25.6361 -5.15185 -28.4625 +9277 4 38.1256 32.9508 11.8227 6.04426 17.9062 13.2724 +9278 4 39.1779 33.654 12.756 21.0695 -5.21903 12.1581 +9279 6 35.6902 3.04562 37.6746 -3.39904 8.35156 -7.25132 +9280 4 35.0929 2.54933 38.2324 -5.1037 -10.0227 3.00486 +9281 4 35.8394 3.86187 38.1597 5.81883 9.20211 1.39187 +9282 6 31.3375 37.3986 35.3773 -3.71028 -11.6357 31.0668 +9283 4 32.2621 37.6229 35.4422 12.7398 8.80293 9.59752 +9284 4 31.1956 37.5429 34.4696 -8.56261 0.879722 -41.7472 +9285 6 52.0699 11.7425 14.0188 13.7235 -2.71131 -30.9774 +9286 4 51.8967 11.0942 13.2788 12.7756 18.36 20.3091 +9287 4 52.777 12.3878 13.7226 -29.9657 -23.6346 9.26958 +9288 6 26.3494 3.44143 41.0133 25.155 -37.875 16.6614 +9289 4 25.5593 3.94137 41.1232 -17.1598 23.2709 -17.7277 +9290 4 26.8278 3.58917 40.1822 -8.59815 12.7626 -4.44352 +9291 6 24.371 34.9599 11.1571 26.4033 32.6711 -2.50587 +9292 4 24.3639 34.5741 12.011 0.42503 -6.32387 38.1824 +9293 4 23.9976 34.2869 10.6415 -25.866 -31.4028 -29.8537 +9294 6 32.0031 7.59722 31.2247 -0.72006 7.33901 18.8157 +9295 4 32.1508 7.36357 30.327 0.345644 0.817488 -27.7554 +9296 4 31.6126 8.48818 31.2118 -2.13527 -8.40442 2.30992 +9297 6 28.7291 2.6069 0.424694 -24.9548 -1.7826 -18.2237 +9298 4 29.2265 2.34055 41.548 2.55638 3.32464 9.52498 +9299 4 27.7798 2.59721 0.142899 25.7986 3.33204 9.63582 +9300 6 42.1267 19.2107 9.86358 19.9254 -1.00598 31.807 +9301 4 42.7282 19.2504 10.675 -28.0191 -3.63038 -32.4782 +9302 4 41.4654 18.506 9.99331 2.41107 5.70909 -2.24499 +9303 6 33.0117 27.0899 8.33041 6.96541 -9.8522 -22.9567 +9304 4 33.8754 26.9804 7.88875 -4.89246 2.6856 6.68054 +9305 4 33.1889 27.2976 9.23992 7.88062 7.04275 14.0068 +9306 6 4.17016 8.31297 19.162 0.312608 -23.727 -31.8356 +9307 4 4.57057 7.90515 18.3575 7.98956 13.418 22.158 +9308 4 3.24181 8.25888 18.9046 -6.31749 7.79174 9.16769 +9309 6 20.797 29.1851 37.0682 -78.8245 -16.0462 -5.4556 +9310 4 20.936 28.2326 36.9784 16.4861 -0.723813 3.66436 +9311 4 21.5674 29.6886 37.0761 54.0195 18.5923 4.39527 +9312 6 13.113 4.99943 10.9253 0.843453 12.9862 -7.21248 +9313 4 13.3812 5.91092 11.1622 0.48683 -16.0572 0.936043 +9314 4 12.7752 5.03128 10.0238 -4.21215 6.55392 -0.64752 +9315 6 37.5015 18.1018 32.5195 21.2703 25.6519 14.9603 +9316 4 38.1786 18.7738 32.2234 -25.3038 -17.5123 8.13315 +9317 4 37.1867 18.4103 33.3985 6.70568 -0.056708 -13.7279 +9318 6 17.7491 33.2689 30.7387 4.64458 14.8517 -20.1826 +9319 4 17.8421 33.9996 30.1068 1.39741 -2.79987 6.34018 +9320 4 18.5541 33.2627 31.2599 6.50121 5.74528 2.59283 +9321 6 23.1871 32.777 9.90494 7.13269 10.4795 -4.3903 +9322 4 23.4604 31.94 10.2921 1.41378 -5.3263 0.807867 +9323 4 22.2339 32.7251 9.74224 0.938735 -0.283076 -0.953242 +9324 6 14.8916 9.36878 34.2544 -3.17606 -9.25219 -4.09189 +9325 4 15.4257 8.57154 34.1751 4.23415 -4.52565 -0.814207 +9326 4 15.1936 9.94604 33.5417 3.33837 13.7034 4.88209 +9327 6 31.123 39.3556 38.5725 10.4581 -15.7875 9.507 +9328 4 31.6408 38.6334 39.0195 -17.0405 19.4438 -10.5616 +9329 4 30.3963 38.9123 38.1137 2.26745 0.847431 0.999129 +9330 6 5.28935 34.441 28.2777 -1.85934 -10.7383 -20.8922 +9331 4 5.27738 35.3973 28.3959 -1.64374 -0.931958 4.82044 +9332 4 5.15855 34.3195 27.3212 3.56171 0.206479 13.9304 +9333 6 30.3161 21.6889 14.1169 -2.08187 28.5408 26.4102 +9334 4 30.4824 20.7856 14.3415 3.20532 -20.0191 -7.60805 +9335 4 30.3589 21.8902 13.1869 1.55029 -10.1196 -17.5522 +9336 6 23.85 39.0046 28.2977 69.4329 26.2515 4.57453 +9337 4 23.9916 39.6084 27.5499 -13.57 2.08121 2.63988 +9338 4 23.036 38.5875 28.2612 -60.5143 -23.8938 -11.8576 +9339 6 9.59742 13.5396 16.4589 33.261 19.9292 -8.86772 +9340 4 8.78625 13.0496 16.3926 -14.9619 -4.96746 -5.567 +9341 4 9.78335 13.9533 15.5888 -9.09133 -14.4247 9.50074 +9342 6 25.9705 6.17968 15.7985 42.799 -23.1477 28.9675 +9343 4 26.019 6.01901 14.8637 -2.75181 4.35539 -17.3872 +9344 4 26.7603 5.64791 16.135 -36.9143 25.7793 -10.0513 +9345 6 15.9952 33.6108 22.5498 -1.32684 21.179 0.174096 +9346 4 16.0845 34.132 21.7265 -5.08009 -17.3545 9.33233 +9347 4 16.0452 32.6693 22.2946 2.44519 21.8582 -2.86748 +9348 6 40.6954 13.5457 12.1293 -5.68603 3.79069 10.9638 +9349 4 40.3939 13.0592 11.3555 -1.07855 -14.0058 -3.54454 +9350 4 41.0539 12.9031 12.7626 -3.06611 3.62129 -5.67307 +9351 6 35.5822 40.2773 31.6862 -1.2862 -13.706 14.6905 +9352 4 36.0451 40.9783 31.2154 -1.32327 -4.34646 -14.1397 +9353 4 35.653 39.3915 31.2603 0.648621 22.1552 -3.29488 +9354 6 19.3539 17.5757 17.8527 24.8545 64.4629 -5.36553 +9355 4 19.9703 18.4106 17.9379 -31.776 -45.1138 0.798127 +9356 4 18.7059 17.8424 17.1823 2.41282 -7.28307 3.58563 +9357 6 7.95249 28.0742 10.7793 26.3782 25.043 4.49745 +9358 4 8.50313 28.8396 11.0908 -15.1612 -19.5627 1.83511 +9359 4 7.20779 28.4792 10.322 -5.34026 -2.34355 -4.06419 +9360 6 32.1473 39.5951 16.6478 -17.9563 1.55165 -8.91142 +9361 4 31.6569 40.3908 16.3404 14.2892 -12.9666 6.03874 +9362 4 31.5266 38.8716 16.4637 6.06753 4.48602 8.64925 +9363 6 35.7883 2.63292 18.1275 9.48574 -34.9606 14.0071 +9364 4 34.8666 2.32593 18.1793 13.7366 6.70894 -2.41967 +9365 4 35.7792 3.51083 17.8116 -6.62646 29.9084 -15.3578 +9366 6 14.9404 39.9496 36.887 -3.95865 -34.2615 35.0372 +9367 4 15.4649 39.4425 36.2826 11.0028 -6.45738 -16.6057 +9368 4 15.0284 40.8419 36.6608 5.56286 51.7396 -15.8162 +9369 6 18.3052 32.4025 11.469 7.68428 8.43447 19.219 +9370 4 18.6311 32.5236 12.4045 -8.3236 -1.07971 -30.5152 +9371 4 17.8613 33.2392 11.223 7.02035 -14.738 0.639166 +9372 6 14.6021 10.381 5.00501 12.904 -5.64335 9.41677 +9373 4 13.6938 10.4305 4.69945 -10.3065 0.63937 1.1744 +9374 4 14.613 10.0418 5.92181 -1.23128 6.20644 -15.3767 +9375 6 2.02771 14.3355 39.1727 -5.84559 30.0988 4.34298 +9376 4 2.70173 15.0418 39.0898 -4.78946 -14.8923 5.30178 +9377 4 1.28797 14.7602 39.6738 10.0694 -17.377 -15.1558 +9378 6 7.58332 14.1556 32.4652 3.8824 27.7869 10.7592 +9379 4 6.9433 13.665 32.9756 -4.43494 -6.18284 1.69377 +9380 4 7.54129 15.0698 32.8492 6.23928 -24.1467 -15.6449 +9381 6 6.15722 23.1341 37.6504 -34.5618 -50.1938 -2.0692 +9382 4 6.56488 23.96 37.7745 13.4151 41.4847 -0.267706 +9383 4 5.38195 23.2242 37.0516 20.9526 5.02196 8.70483 +9384 6 37.2952 22.537 4.44472 51.3933 75.9823 3.75371 +9385 4 36.5074 22.1342 4.18978 -47.7056 -22.8011 -17.3868 +9386 4 37.221 23.5361 4.21623 -3.53185 -51.7458 12.1203 +9387 6 47.1368 31.0168 5.89375 -14.3926 17.1884 -69.1718 +9388 4 46.9718 30.7968 6.77028 -10.6218 -7.91998 56.0799 +9389 4 46.2684 31.351 5.53353 23.0456 -16.9797 4.17914 +9390 6 54.8109 25.5937 34.9376 16.0179 27.3393 -6.0446 +9391 4 54.0726 25.4665 35.5517 -1.08617 7.29827 -2.61058 +9392 4 0.161491 26.54 35.0366 -21.9365 -36.0956 3.57937 +9393 6 37.1499 2.07739 4.80452 -1.94348 22.0087 -45.3652 +9394 4 36.668 2.89852 4.54683 5.06511 -19.4283 11.9563 +9395 4 37.1062 1.96831 5.73813 -4.74438 -1.19387 27.2393 +9396 6 22.5142 28.609 8.91066 14.7838 -0.767913 33.3492 +9397 4 22.9803 28.3541 9.73828 -15.565 12.7605 -7.61321 +9398 4 22.8168 27.9481 8.31925 3.93055 -13.9923 -25.0246 +9399 6 8.64284 27.1533 24.5627 -30.3364 66.7798 9.61681 +9400 4 7.68564 27.0552 24.6389 4.16714 -15.7471 -5.05425 +9401 4 9.10482 26.3676 24.4825 22.9633 -64.4218 -6.53839 +9402 6 1.14841 23.7276 2.43845 3.37143 2.75553 -28.3576 +9403 4 1.24451 23.8913 1.47114 -2.40676 3.6179 20.3541 +9404 4 0.297784 23.2877 2.48462 -2.13531 -2.42607 6.29474 +9405 6 54.3749 30.2279 27.0351 -1.87188 5.01086 -25.6864 +9406 4 54.247 29.4439 26.4851 0.283672 1.58093 2.67322 +9407 4 54.589 30.9178 26.3677 -1.31459 -2.18642 16.2549 +9408 6 0.382292 8.43516 23.9819 16.8945 -11.9539 9.7221 +9409 4 1.32445 8.60369 24.1565 -2.20413 -11.2301 -8.89161 +9410 4 54.9553 8.73001 24.7921 -9.77823 11.7559 2.768 +9411 6 16.9131 28.5848 33.3683 -2.23593 -25.3201 -21.0962 +9412 4 17.3654 28.7863 34.1955 9.02781 -2.88055 -0.915496 +9413 4 17.3951 27.8627 32.8656 -13.2947 27.9561 26.4245 +9414 6 33.6945 30.8881 0.140848 11.5734 5.16226 7.65985 +9415 4 34.5903 30.4955 0.196618 -6.50407 7.83028 -3.90982 +9416 4 33.2725 30.4522 41.313 0.902851 -8.5209 -4.03004 +9417 6 16.2572 21.5133 34.1618 -1.32279 -12.2579 -0.0768877 +9418 4 15.8666 20.7686 33.6578 14.5936 10.7995 5.0381 +9419 4 16.7742 21.1109 34.8905 -13.5083 8.43335 -11.1581 +9420 6 0.208862 17.804 35.7536 -14.601 -29.9007 -2.72034 +9421 4 54.2286 17.807 35.5323 33.4083 9.0609 14.8615 +9422 4 0.362977 16.9429 36.1939 -0.60553 13.4006 -6.21859 +9423 6 16.8205 12.2987 0.018055 22.2965 10.2312 29.8095 +9424 4 17.2696 12.8062 0.753963 -11.4311 -8.71934 -28.0399 +9425 4 16.617 11.4478 0.422257 -11.1364 1.3302 -4.58262 +9426 6 8.24969 9.53941 36.253 -15.0171 13.8578 -6.15226 +9427 4 7.92627 8.96163 36.9484 -10.0154 -4.61382 -0.313479 +9428 4 7.46687 9.9886 35.83 14.4541 -3.15884 14.1629 +9429 6 48.5699 26.7153 39.8372 -6.05787 -6.72914 15.0837 +9430 4 48.3449 26.8926 38.9385 -16.4424 3.29077 -18.6566 +9431 4 49.4571 27.0352 39.8842 23.4859 3.73228 5.76721 +9432 6 35.4844 1.07048 23.1169 11.4549 30.8088 37.1655 +9433 4 36.0158 1.76714 22.6808 -9.17201 -14.7916 0.90361 +9434 4 35.6328 1.27141 24.1103 0.373025 -19.0496 -44.6811 +9435 6 20.2784 30.6315 19.3752 23.9103 -21.6662 15.3888 +9436 4 20.3116 31.0532 20.259 -5.42732 -3.95571 -8.57186 +9437 4 20.9344 29.8759 19.4191 -22.0709 25.9102 -5.54449 +9438 6 44.3706 15.9499 1.58551 5.68582 14.4456 12.9619 +9439 4 44.3685 15.5676 2.49167 2.87795 14.7015 -16.764 +9440 4 44.6274 16.9163 1.6094 -6.5628 -31.3198 6.45039 +9441 6 53.8881 34.4681 10.5864 -33.0496 11.7448 -26.9592 +9442 4 54.422 34.2751 11.3149 32.4161 -9.35278 40.7994 +9443 4 54.2788 35.2396 10.1584 -0.0979649 -6.0993 2.73708 +9444 6 46.1388 32.8516 33.5211 5.22207 -15.0187 3.22626 +9445 4 45.9452 33.6327 33.0044 -1.75723 11.2428 -3.91525 +9446 4 47.0422 32.5752 33.2841 -5.1447 4.42718 0.252344 +9447 6 42.1248 21.9061 24.225 29.3467 -8.59285 14.1471 +9448 4 43.0897 21.6191 24.2618 -39.2895 4.06832 7.69751 +9449 4 41.7308 21.6944 25.1042 13.707 1.91177 -18.5137 +9450 6 8.13464 3.90485 11.6471 19.3767 -1.70453 -18.8264 +9451 4 7.33962 4.19894 12.0861 -8.05938 -6.79837 10.6821 +9452 4 8.35918 3.01511 11.9412 -4.68297 1.80025 9.46807 +9453 6 19.6422 41.6776 9.83213 -10.6455 12.1827 13.5714 +9454 4 18.8651 41.1405 9.66265 4.99962 -3.76564 -7.41899 +9455 4 19.3487 0.264237 10.6212 9.02518 -11.5641 -14.6522 +9456 6 42.3073 8.42404 31.6799 28.9247 6.2763 -10.2166 +9457 4 41.4386 8.38933 32.0551 -18.7028 2.48038 0.978172 +9458 4 42.5266 9.37939 31.5704 -3.99861 -19.3235 1.7837 +9459 6 26.9144 16.155 25.3557 3.37886 4.46922 -29.1574 +9460 4 26.8932 15.8089 24.4276 -4.09623 14.1183 21.5023 +9461 4 26.5944 15.4425 25.8888 -2.2842 -17.5105 15.3426 +9462 6 48.2339 6.48607 12.6213 -2.32796 -4.32122 -9.13051 +9463 4 48.9884 6.29985 12.0375 -6.36801 1.93824 2.64233 +9464 4 47.4521 6.15437 12.1363 8.14441 0.739204 7.03502 +9465 6 53.4551 41.5313 30.6545 -6.55363 -20.9747 -16.7061 +9466 4 53.9707 41.8328 29.895 1.38615 3.54438 2.31965 +9467 4 53.5938 0.199493 31.3858 11.9182 14.0856 15.8016 +9468 6 47.0766 22.4304 31.8083 3.49024 11.2606 -9.33253 +9469 4 47.8957 22.458 31.249 -27.0486 7.80914 13.6686 +9470 4 46.5597 23.2507 31.6033 14.3992 -20.3875 6.89099 +9471 6 19.5103 5.43818 15.252 80.4346 7.77941 -36.259 +9472 4 19.9845 4.58151 15.2093 -6.94904 10.3389 3.32724 +9473 4 18.6939 5.26573 15.6196 -64.0069 -9.45641 27.6942 +9474 6 14.6723 30.2358 33.3977 29.3194 14.0021 -15.573 +9475 4 15.2147 30.9127 32.9173 -16.9191 -15.4944 5.99358 +9476 4 15.2716 29.4658 33.3729 -9.39086 7.05787 2.01807 +9477 6 28.44 24.2314 10.4028 3.15123 -12.4056 -9.54268 +9478 4 29.226 24.4262 10.8786 32.4584 2.85658 2.79411 +9479 4 27.8296 24.5485 11.0342 -36.3144 6.15546 12.0187 +9480 6 5.27118 14.4387 24.4945 35.1445 25.2092 -0.0633509 +9481 4 4.43594 14.1516 24.7736 -48.8682 -19.2375 4.52664 +9482 4 5.4685 14.0235 23.6561 -3.04719 -11.4521 -9.99341 +9483 6 26.3524 19.2908 19.1818 20.1263 -20.0506 -24.4735 +9484 4 26.6388 20.1349 19.5116 -1.98461 18.5008 5.62334 +9485 4 27.0961 18.9592 18.5977 -26.1102 9.18548 27.2368 +9486 6 28.5758 7.44193 13.1857 16.8206 36.5977 2.40675 +9487 4 28.4276 6.5743 12.8854 -8.83608 -34.241 -6.14436 +9488 4 29.1296 7.84613 12.4994 -7.23682 2.38597 3.89632 +9489 6 5.36882 27.1473 37.046 11.8823 -4.88323 19.1587 +9490 4 6.08575 26.9595 37.7076 -19.1456 -1.45009 -21.6041 +9491 4 5.36685 28.0942 36.8598 5.86896 -0.355799 -4.60773 +9492 6 53.1378 13.4025 16.0996 34.2435 -3.86055 5.06914 +9493 4 54.0829 13.0966 15.9504 -32.0077 5.91706 2.7318 +9494 4 52.5847 12.6783 16.4422 5.4814 -0.344951 -11.4066 +9495 6 45.452 1.01889 24.6154 3.31322 11.7394 9.54943 +9496 4 44.8157 0.989703 23.8982 -3.33354 -4.25493 -1.52857 +9497 4 44.9019 0.844105 25.4008 9.82267 -2.51687 -6.81685 +9498 6 50.1641 2.37547 13.9256 -5.79196 7.9049 4.59273 +9499 4 50.7992 2.78767 13.3238 -3.84891 -0.754592 0.637936 +9500 4 49.4746 3.0334 14.0873 2.34893 4.7321 -2.13859 +9501 6 19.5803 31.0161 39.1628 -18.0613 -25.9328 -11.5794 +9502 4 19.7424 30.2951 38.4816 -0.347779 24.7736 22.083 +9503 4 18.6224 30.9377 39.4182 28.2801 4.19594 -11.375 +9504 6 19.2561 14.7051 10.8744 35.9018 -50.5273 5.13524 +9505 4 20.0412 14.097 10.5737 -45.0165 49.548 5.48727 +9506 4 18.7602 14.0269 11.3662 -4.16951 16.5755 -2.6658 +9507 6 4.45594 39.5485 20.1375 -7.26247 21.8372 28.3356 +9508 4 3.95576 40.4005 20.2782 15.6699 -22.2203 -5.74536 +9509 4 4.87483 39.3065 21.0019 -15.4768 4.14169 -24.4646 +9510 6 29.0152 13.3442 23.91 8.01267 35.4951 15.4816 +9511 4 28.7225 12.4574 23.7464 -4.82052 -12.6612 5.31893 +9512 4 28.8407 13.5397 24.8723 9.679 -4.85246 -32.6651 +9513 6 17.068 2.76349 17.6602 17.5731 -10.7754 -19.6116 +9514 4 16.9152 3.43747 16.9733 0.569879 -2.90947 3.06519 +9515 4 17.8166 2.20316 17.3149 -21.6663 12.1671 7.12297 +9516 6 43.4725 18.0406 17.7144 -1.44781 -24.3706 15.3127 +9517 4 43.4291 17.0524 17.7495 6.1749 24.1268 -14.107 +9518 4 43.576 18.2305 18.6573 0.474252 7.4982 -2.94392 +9519 6 25.7765 40.7491 1.25834 -5.13784 -8.67992 -41.8469 +9520 4 26.3241 41.1434 1.92597 2.9618 17.1891 5.50682 +9521 4 25.7331 41.3641 0.469204 -4.81559 -13.5206 29.0343 +9522 6 0.465549 22.8917 6.22214 -2.55797 -7.94984 -3.9446 +9523 4 0.971697 22.1453 5.8424 -8.20264 3.34524 4.91565 +9524 4 1.09943 23.372 6.75946 4.60597 5.6548 -4.31438 +9525 6 26.241 35.011 18.6432 -1.36099 17.7753 -9.20742 +9526 4 25.9471 35.9461 18.6768 6.76043 -15.7179 -8.96745 +9527 4 25.6107 34.5957 19.2286 4.79325 -10.2415 3.05652 +9528 6 16.134 31.8742 7.55305 63.3701 -24.5537 -22.1036 +9529 4 16.96 31.3344 7.22221 -43.8871 18.402 28.1533 +9530 4 16.2567 32.6659 7.02685 -6.92396 6.43503 -6.66113 +9531 6 22.9365 16.8424 28.5556 -11.8911 28.7995 -6.03551 +9532 4 23.1131 16.1224 27.957 -2.92592 -13.6094 -7.1053 +9533 4 22.1672 17.3806 28.2048 22.5292 -24.3034 15.5849 +9534 6 48.8154 29.3426 32.1508 17.6607 -5.63259 25.101 +9535 4 47.9338 29.1776 31.8283 -15.752 -0.354552 -3.67809 +9536 4 48.876 28.9209 33.0523 -3.3832 13.4569 -22.7771 +9537 6 13.1275 24.861 5.55911 -24.9858 12.0714 -24.023 +9538 4 12.9095 24.1076 4.98414 3.68764 2.77663 3.09454 +9539 4 12.4428 25.5491 5.3163 19.4298 -17.0083 16.84 +9540 6 10.97 20.7168 15.838 25.2219 -21.2413 -18.4662 +9541 4 10.9273 20.4774 14.8836 -9.78471 10.8905 20.232 +9542 4 11.8407 20.3068 16.0784 -25.4832 11.5027 -0.03881 +9543 6 13.8668 18.3675 6.9377 -17.1805 34.1284 -15.5183 +9544 4 13.9861 19.3268 7.07801 0.95534 -8.68107 -9.41428 +9545 4 14.2312 17.9937 7.71618 14.696 -22.4056 21.3209 +9546 6 13.8328 12.9436 30.6366 23.8936 8.4875 1.93436 +9547 4 14.0561 12.5213 29.7889 -15.7862 -10.4805 9.2002 +9548 4 13.0857 12.5134 31.0734 -5.46762 -5.09599 -12.1481 +9549 6 17.1276 6.33232 31.2677 66.6528 76.8842 26.6004 +9550 4 16.7194 7.19542 31.0916 2.25558 -4.54354 -1.53399 +9551 4 16.4872 5.75051 31.0533 -74.7845 -70.3194 -26.0669 +9552 6 7.63688 23.4278 20.549 2.87884 3.81634 -6.68902 +9553 4 7.34623 23.1229 19.6666 2.94756 -0.449201 10.6329 +9554 4 8.04096 24.3016 20.3852 -3.87648 -11.4978 -1.95405 +9555 6 15.5875 36.6622 25.6317 44.8659 35.0544 -6.16252 +9556 4 16.5723 36.6215 25.7443 -25.3852 -14.6967 7.558 +9557 4 15.5456 37.5452 25.2115 -8.92727 -11.7797 -1.50769 +9558 6 0.738994 10.4213 22.1809 -27.1543 -36.2471 -13.1925 +9559 4 0.031346 10.3136 21.4752 22.4259 7.4169 21.1377 +9560 4 0.614162 9.62536 22.7539 0.837437 23.266 -16.3015 +9561 6 33.4753 17.3986 33.5966 50.0322 34.9653 -25.691 +9562 4 33.729 18.3684 33.3861 -23.79 -42.9591 12.1009 +9563 4 34.1104 16.8695 33.0603 -9.99519 5.32569 13.787 +9564 6 21.6594 19.0069 20.7632 22.9673 -17.6764 -6.78691 +9565 4 22.3468 19.6741 20.9606 -3.94962 -13.1079 -1.95693 +9566 4 22.1476 18.14 20.6003 -16.6978 33.0759 6.74927 +9567 6 41.7633 20.003 16.8748 -11.326 -1.31128 -8.84591 +9568 4 42.2034 19.1563 16.9874 6.48398 -7.2756 0.328325 +9569 4 41.4682 20.0367 15.9399 8.87316 5.12137 10.7952 +9570 6 12.0358 14.9766 17.6999 -26.21 -7.2152 -26.0517 +9571 4 11.2991 14.5498 17.1995 11.2858 13.8526 14.1879 +9572 4 12.4764 14.2447 18.105 9.10187 -13.3837 13.9354 +9573 6 23.0147 11.4211 40.7142 -19.9953 11.3897 74.5259 +9574 4 22.9359 12.2968 41.1901 4.60696 -23.5555 -21.1396 +9575 4 23.3157 11.5565 39.857 19.7433 14.0142 -51.5111 +9576 6 21.0056 28.3023 24.5803 -69.1041 85.2373 -40.9106 +9577 4 20.265 28.1264 25.1705 5.37048 -3.26467 3.49678 +9578 4 21.6928 27.7549 24.7451 59.1792 -66.0576 27.8401 +9579 6 19.39 13.7159 31.9239 29.4118 -13.0288 15.1298 +9580 4 18.7661 13.9847 31.2678 -13.3276 3.02657 -9.68553 +9581 4 18.8827 13.5849 32.728 -3.24577 4.6437 7.00982 +9582 6 21.5915 2.84466 24.7134 0.208747 24.5944 -29.04 +9583 4 21.6872 3.18692 23.7998 -4.92058 -5.74628 13.5023 +9584 4 22.4885 2.58061 24.905 3.18231 -12.543 15.1704 +9585 6 11.3458 29.9955 18.8336 12.03 22.8495 18.6886 +9586 4 10.5716 30.5896 18.8018 6.29595 -15.7791 -4.99952 +9587 4 11.9743 30.476 19.4324 -17.0963 -23.9187 -22.0967 +9588 6 14.6495 22.3648 8.3568 42.8177 1.00499 7.23029 +9589 4 14.0031 23.0587 8.53935 2.83958 6.20927 5.13977 +9590 4 15.5993 22.7606 8.33857 -60.0645 -13.0658 0.526795 +9591 6 43.9468 23.6541 17.2812 -2.43742 26.8438 -12.7514 +9592 4 44.7651 23.2701 16.9945 19.1668 -3.91001 -9.18188 +9593 4 43.5028 22.9 17.6346 -11.2125 -8.13016 15.2757 +9594 6 28.0047 25.4978 27.5091 9.49546 -35.4414 -7.32855 +9595 4 27.536 26.3032 27.53 -22.6173 33.7003 2.08289 +9596 4 28.9082 25.7508 27.3241 10.2254 5.98924 0.98151 +9597 6 19.1021 26.8113 33.1456 6.96794 1.44941 -44.6281 +9598 4 19.0009 26.3889 32.2316 6.61058 22.4795 36.193 +9599 4 19.4537 27.7357 32.9996 -8.5054 -25.835 6.12407 +9600 6 6.37601 19.3499 5.67113 -3.07724 -15.511 8.20386 +9601 4 6.68786 20.0294 5.07731 7.18653 8.65774 -7.7972 +9602 4 5.56195 19.7092 6.03854 -2.87224 2.62267 4.46635 +9603 6 37.49 28.403 9.68405 -10.2736 -31.6176 -26.4717 +9604 4 37.8518 27.9475 10.4351 5.1765 10.0485 19.5132 +9605 4 37.3493 27.6251 9.09625 -2.69325 25.3221 7.01666 +9606 6 17.6998 27.0953 11.7898 -36.7906 -34.4972 13.5582 +9607 4 17.0141 26.488 11.3694 25.6316 27.0728 3.78529 +9608 4 17.4298 27.07 12.7376 6.94557 14.4563 -18.9236 +9609 6 12.8888 1.93962 24.1529 -50.3802 38.9184 -15.728 +9610 4 12.0235 2.45928 24.1313 32.0413 -19.6529 -17.3906 +9611 4 12.9222 1.7892 25.0724 13.055 -19.4335 33.1456 +9612 6 27.8476 37.1183 33.3015 17.2618 -5.56645 -20.6455 +9613 4 27.8725 37.7306 32.5366 -3.66202 -8.07766 15.1749 +9614 4 28.4268 36.3488 33.0405 -13.8477 22.6944 8.61763 +9615 6 18.6736 12.3707 6.31908 6.91225 -31.4632 27.4828 +9616 4 18.6995 11.385 6.25383 -9.67628 20.7874 -2.26223 +9617 4 18.5836 12.6888 5.4344 -4.12511 6.2973 -26.1687 +9618 6 10.1784 29.305 24.7735 -9.10204 -23.9111 21.4033 +9619 4 10.6991 28.9855 25.5395 2.35147 16.2142 -6.30056 +9620 4 9.48939 28.598 24.7147 15.6456 22.7499 -9.47694 +9621 6 7.25796 3.28933 16.2737 -3.06701 21.6066 -7.53298 +9622 4 7.8017 4.02386 16.6541 -5.18893 -18.6288 5.77884 +9623 4 6.83195 2.7267 16.9458 19.6595 6.39335 -0.783342 +9624 6 32.1965 37.5589 1.11244 17.7564 -13.393 -49.4834 +9625 4 31.8113 36.9118 1.6863 -14.8068 -2.94474 23.9511 +9626 4 32.3136 38.4192 1.49585 -8.3749 16.0852 25.1081 +9627 6 10.4319 10.1504 6.4166 -7.63199 8.14139 10.6713 +9628 4 9.50403 10.3698 6.52583 -9.38347 6.87647 -8.77798 +9629 4 10.8186 10.5343 7.22249 5.92406 -9.68277 -8.25616 +9630 6 16.1813 23.2506 37.3799 25.1097 11.6639 -4.85114 +9631 4 16.5396 23.4181 38.2693 -7.5274 5.30939 -3.10176 +9632 4 16.7237 23.8262 36.781 -18.6662 -9.83464 11.0165 +9633 6 24.0859 14.3313 36.5421 -9.86516 7.30801 -0.382215 +9634 4 25.0278 14.1902 36.5644 12.4097 -8.07045 3.76472 +9635 4 23.7255 13.9571 37.3615 2.98939 6.5027 1.55174 +9636 6 27.4763 18.5532 28.7891 -13.5271 -4.91773 7.22809 +9637 4 27.279 18.1935 29.6763 -0.617381 3.48163 -16.8994 +9638 4 26.6639 18.4733 28.2428 3.34183 3.33207 10.806 +9639 6 51.5601 10.4909 1.56577 -57.9967 -14.5533 -18.7957 +9640 4 50.8004 9.99697 1.98849 19.2905 21.9947 -18.6033 +9641 4 52.233 10.462 2.20044 35.6887 -2.31897 35.1783 +9642 6 31.1159 39.6224 27.5035 10.1927 26.9633 6.19817 +9643 4 30.6636 39.3812 28.2975 -12.6206 -22.2416 8.82104 +9644 4 31.2642 40.5609 27.7597 6.49383 -23.2522 -24.0775 +9645 6 6.91312 35.9708 14.3252 -31.0555 -15.8542 22.3873 +9646 4 7.60399 36.2341 13.7609 26.7748 16.1612 -20.4248 +9647 4 7.14109 35.0698 14.5861 -2.88708 -0.858877 1.78829 +9648 6 45.5543 7.568 29.1737 -25.5302 -4.16762 -2.13202 +9649 4 44.8976 7.53234 28.4293 19.2773 0.699039 20.3251 +9650 4 45.0852 7.16669 29.9393 6.23602 2.26061 -10.7804 +9651 6 31.3622 20.562 31.6184 9.65463 4.63597 0.319717 +9652 4 31.8498 21.4034 31.7895 1.14978 -23.5084 -11.6884 +9653 4 31.8627 19.9392 31.0494 0.180852 16.2895 10.8054 +9654 6 43.0328 31.1512 10.3804 -22.1718 15.2565 33.5805 +9655 4 42.075 30.8844 10.4741 26.7443 4.92622 -3.29861 +9656 4 43.2631 31.5811 11.2548 -4.68507 -19.1463 -31.4268 +9657 6 50.935 25.5526 12.6381 -53.0362 -11.2381 37.5759 +9658 4 50.8444 26.3707 12.1889 6.26198 32.0523 -21.5557 +9659 4 51.7606 25.1556 12.4927 46.8244 -9.35474 -8.90879 +9660 6 29.329 2.97736 3.64421 22.5456 -43.1143 -6.52899 +9661 4 29.5843 3.84773 3.82541 15.3974 46.6652 11.4603 +9662 4 28.3975 3.01514 3.57252 -35.3193 1.84796 -10.7817 +9663 6 53.9306 32.0952 20.3602 -26.044 3.42844 6.98601 +9664 4 54.8587 32.2554 20.2589 13.6369 -3.90514 -8.57062 +9665 4 53.586 31.7345 19.5218 3.48091 2.50952 8.05406 +9666 6 41.7156 29.5544 6.48768 19.5894 27.0766 -19.1548 +9667 4 40.8143 29.536 6.19581 -21.1406 0.0261655 0.681639 +9668 4 42.121 30.2839 5.93213 -7.9284 -21.0777 21.5612 +9669 6 37.8354 24.5725 39.3073 -0.786614 -2.83003 -8.48557 +9670 4 37.3057 24.1981 38.5867 -0.305281 2.91934 11.1175 +9671 4 37.4479 24.2715 40.1417 -1.64355 1.86967 -5.36783 +9672 6 46.558 27.5785 23.289 -39.9634 -64.6481 11.0379 +9673 4 46.4646 27.3918 24.2576 6.74558 16.0433 -18.2165 +9674 4 45.9199 26.8188 22.9475 37.5572 46.869 6.09964 +9675 6 9.22773 27.2022 8.33468 -36.26 12.7871 28.7267 +9676 4 8.91275 27.6129 9.1801 5.62558 -9.89589 -23.2096 +9677 4 10.1414 27.0456 8.46037 35.2783 -3.07459 2.5747 +9678 6 36.0491 34.1608 13.9867 7.26402 -14.0442 8.68546 +9679 4 35.9913 33.1738 14.0461 -7.39622 22.1346 -4.41017 +9680 4 36.7548 34.3393 13.3524 -0.0889916 -4.95725 -2.25698 +9681 6 51.6742 14.4867 12.321 25.1613 25.5512 -24.4042 +9682 4 52.0989 14.4284 11.4335 -6.19684 -3.38259 22.4379 +9683 4 51.9807 15.3554 12.6493 -12.3863 -19.4348 1.31199 +9684 6 15.2583 19.6409 32.4144 29.0083 -20.2623 -33.8133 +9685 4 15.2558 19.2688 31.4922 3.04968 7.12699 22.6875 +9686 4 14.3622 19.8256 32.5802 -41.1763 4.86179 8.56209 +9687 6 27.6812 24.6569 38.3606 -19.0318 -31.8029 -32.3422 +9688 4 27.9736 25.1472 39.0974 14.6808 26.4307 29.745 +9689 4 28.3717 24.6185 37.6939 9.13491 6.22605 4.36089 +9690 6 37.5205 9.26898 13.6241 11.458 -4.07639 -2.41324 +9691 4 37.986 8.73412 14.2818 -4.17908 -1.66932 4.91722 +9692 4 37.422 10.1332 14.0472 -5.80925 -1.58022 -1.38856 +9693 6 20.8962 33.2419 26.2614 5.37543 12.855 -2.41316 +9694 4 21.3204 33.4412 27.1125 -5.30181 -3.15861 -4.46659 +9695 4 20.9369 32.3076 26.1263 8.87353 -20.0108 1.20924 +9696 6 6.59104 13.9455 35.2329 -26.8274 -4.60486 4.58094 +9697 4 6.38745 12.9897 35.2457 11.7642 5.99643 -3.17645 +9698 4 7.53507 14.0926 35.2395 12.5421 -8.77428 2.26249 +9699 6 10.0726 7.48467 6.8792 2.12641 6.95589 -11.9404 +9700 4 9.21804 7.15917 6.5645 -4.80657 -1.75614 5.47812 +9701 4 10.1222 8.42177 6.5916 5.16955 -15.159 7.51812 +9702 6 31.1977 5.95154 11.4339 24.7603 28.3677 15.6689 +9703 4 31.4296 6.16733 12.4018 -4.97657 -8.97631 -41.3224 +9704 4 31.9131 6.32779 10.8565 -11.9651 -11.6794 24.5691 +9705 6 12.1328 3.85103 35.2933 -10.0815 -12.0493 27.5499 +9706 4 12.7851 4.21657 34.7189 20.4312 8.87509 -12.0205 +9707 4 12.5123 3.89786 36.1903 -2.36263 6.36147 -16.6701 +9708 6 5.35168 6.07805 27.6549 3.96089 -18.0524 46.6648 +9709 4 5.01336 6.85569 28.0965 2.16186 8.49085 15.9688 +9710 4 5.1377 6.25223 26.7855 -7.5711 11.2001 -66.4514 +9711 6 13.1382 33.574 1.68419 20.6109 34.6607 2.95503 +9712 4 12.5953 33.0967 1.0817 -13.6453 -8.09858 -18.4215 +9713 4 13.3822 34.4502 1.26439 -11.0211 -27.5174 16.1165 +9714 6 44.6427 10.3996 29.0359 8.91116 23.4714 -13.18 +9715 4 44.4953 9.45294 29.0952 0.434286 -4.87704 -7.20081 +9716 4 44.1618 10.7755 28.2587 -0.00111917 -13.6507 16.636 +9717 6 9.15295 24.5944 6.37753 4.35763 15.0755 22.3214 +9718 4 8.87327 24.2546 5.53613 0.42871 5.14079 -20.2862 +9719 4 9.64462 25.4438 6.24707 -3.48643 -17.4971 -5.55606 +9720 6 52.5676 27.2719 21.6547 -2.39965 -30.061 -11.5856 +9721 4 52.5233 26.307 21.7841 0.332471 11.3908 13.792 +9722 4 52.7558 27.2791 20.7178 5.02488 16.4903 -8.77251 +9723 6 7.3066 16.9604 33.5537 -1.04195 2.49046 -7.43677 +9724 4 7.33543 17.7138 32.943 1.81348 -0.803559 0.920864 +9725 4 6.38938 16.6816 33.595 -7.62852 -0.129201 -7.36731 +9726 6 43.922 25.2186 7.97522 -0.776236 -10.551 19.3716 +9727 4 43.2647 24.8119 8.58447 10.2741 2.86697 -16.6436 +9728 4 43.4353 25.9147 7.53069 -5.46224 6.25576 -5.43654 +9729 6 2.0869 27.1165 13.6049 -6.62274 17.6596 -9.16822 +9730 4 2.19606 26.2295 13.9488 0.235583 -10.4047 3.43352 +9731 4 2.56841 27.1544 12.7597 2.10867 -4.70259 8.20201 +9732 6 37.3318 18.2771 2.1863 -11.4974 3.81579 3.71073 +9733 4 37.5653 17.6745 1.47223 -1.7687 -9.97531 1.83125 +9734 4 36.746 18.9091 1.7765 -5.93566 5.03593 -3.95155 +9735 6 24.9999 10.057 0.434977 -12.0635 -2.74649 0.799886 +9736 4 24.3308 10.4048 41.7106 3.78591 -9.33137 12.164 +9737 4 24.5954 9.37599 1.02184 5.69483 17.6459 -16.041 +ITEM: TIMESTEP +10 +ITEM: NUMBER OF ATOMS +9737 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 5.4990000000000002e+01 +0.0000000000000000e+00 4.1909999999999997e+01 +0.0000000000000000e+00 4.1909999999999997e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 9.97007 5.59928 0.0158605 6.82717 25.1566 0.173859 +2 2 9.62356 5.56404 40.5109 2.42388 15.8202 -17.9785 +3 2 8.17494 6.05177 40.4142 55.7411 37.9916 -4.02595 +4 3 7.24177 5.30408 40.552 -31.6102 -16.3698 1.50252 +5 4 9.18703 5.26911 0.576869 6.09491 -0.0281501 2.37507 +6 4 10.258 6.55078 0.333037 -13.6694 -25.1619 -9.93433 +7 4 10.7495 5.00053 0.227298 4.73684 -5.2578 1.97242 +8 4 10.3453 6.24708 39.9044 -16.4644 -11.4072 20.4818 +9 2 9.76873 4.13927 39.9675 -11.4588 -40.6165 34.779 +10 2 9.50273 3.78744 38.4932 15.666 28.6261 8.68394 +11 5 10.1133 2.12508 38.0108 0.295651 13.5297 3.11239 +12 2 9.21855 1.10832 39.2168 14.7368 7.58368 -1.20954 +13 4 9.08721 3.4839 40.6484 10.5431 15.7462 -21.5186 +14 4 10.7894 3.80905 40.2705 3.27862 -1.66199 -9.78219 +15 4 9.96352 4.6291 37.9056 6.4614 -19.967 -0.497951 +16 4 8.45197 3.92389 38.2658 -20.9649 -8.28542 -1.62155 +17 4 9.45855 1.42591 40.2577 0.123087 -4.74543 -3.47868 +18 4 9.48787 0.0601841 39.0477 5.23249 -11.9374 1.58081 +19 4 8.1518 1.18086 39.043 -21.148 5.31153 -2.14239 +20 1 8.09229 7.41048 40.3029 -14.2332 10.7223 -5.89196 +21 2 6.79937 8.10304 40.1889 5.24089 -19.8495 27.4218 +22 2 6.18195 7.49232 38.9365 0.114954 6.75236 -38.7125 +23 3 6.7427 7.67352 37.8124 -12.8129 -5.94191 21.2876 +24 4 8.91546 8.03754 40.1502 -4.33809 -15.705 2.93584 +25 4 6.18636 7.83053 41.1247 8.71228 4.86543 -21.2479 +26 2 7.05427 9.64124 40.1755 -39.1485 4.05492 14.7867 +27 2 5.78354 10.5475 40.1236 1.30256 17.7056 10.1762 +28 2 4.88546 10.5193 38.8862 -3.79578 -25.0164 33.8013 +29 3 5.09523 11.2746 37.9701 4.75276 20.2207 -26.2166 +30 1 3.8145 9.69296 38.9578 -10.6259 3.8922 -22.0733 +31 4 7.59986 9.93872 39.279 22.1314 0.316188 -7.87442 +32 4 7.59095 9.90263 41.1476 2.09094 2.02455 -19.3111 +33 4 6.10317 11.6308 40.2015 3.5236 -15.0099 -9.27626 +34 4 5.16114 10.4864 41.0336 -3.30627 -13.4665 3.57605 +35 4 3.54863 9.07856 39.7488 8.69916 3.95403 -0.745788 +36 4 3.18874 9.68238 38.1158 12.5738 1.24403 17.0425 +37 1 5.02604 6.79083 39.0278 7.4524 -0.797845 -45.9123 +38 2 4.17847 6.29332 37.9221 -3.7942 -15.2224 -3.95324 +39 2 2.69747 6.67222 38.2029 32.4064 16.6491 21.8024 +40 3 2.47317 7.27763 39.2627 -13.9875 -5.03172 -5.20453 +41 4 4.49693 6.75941 39.8611 -16.5463 3.77927 46.4214 +42 4 4.45927 6.7815 36.9606 1.68834 7.22657 1.16434 +43 2 4.32357 4.73766 37.6872 -14.444 16.6417 -7.09057 +44 2 3.62009 3.87951 38.7772 14.6644 -34.8859 1.43809 +45 2 5.79989 4.34797 37.5209 14.6689 -37.6664 -23.8861 +46 2 3.73665 2.34984 38.4383 -15.0607 27.3941 -9.62179 +47 4 3.8042 4.58537 36.6865 5.44811 -8.07725 9.84866 +48 4 2.54132 4.09064 38.8487 -7.82462 7.38089 1.0406 +49 4 4.05844 4.00808 39.8052 -1.99007 7.91776 -7.51683 +50 4 6.34139 4.39198 38.494 2.7915 9.59572 -3.8015 +51 4 6.26587 4.94741 36.6895 -0.816692 -0.0793993 15.4171 +52 4 5.96503 3.2496 37.1567 -11.5696 29.092 9.48874 +53 4 3.39623 2.18998 37.357 4.41378 -5.40883 18.8177 +54 4 3.12239 1.76276 39.1489 -5.35757 -4.6989 -2.16583 +55 4 4.76682 2.00075 38.5743 10.6291 -5.64517 -2.52342 +56 1 1.71265 6.3536 37.3575 -33.5913 -12.5481 -9.77554 +57 2 0.284755 6.62158 37.6816 12.6554 33.7668 -4.20076 +58 2 54.3822 5.43344 37.3699 -27.7691 3.87457 8.29319 +59 3 54.7838 4.49252 36.6867 3.01204 -3.04336 -3.37779 +60 4 1.82497 5.72672 36.5372 4.10411 3.68048 5.38879 +61 4 0.194803 6.88576 38.7694 2.48378 -12.979 2.09758 +62 2 54.7189 7.90551 36.9466 -7.72609 -12.13 5.61678 +63 2 0.656639 9.069 36.6919 -2.01357 8.03554 13.9604 +64 2 1.52683 9.2194 35.5966 7.55435 5.75852 -14.6577 +65 2 0.515029 10.1503 37.577 28.0972 23.5099 -14.6501 +66 2 2.25128 10.4257 35.3726 -4.96866 -39.5758 -10.6477 +67 2 1.27413 11.3326 37.3973 2.53894 16.486 1.64204 +68 2 2.1477 11.4375 36.2812 10.2448 65.1187 39.3263 +69 4 53.8018 8.25583 37.5371 13.1335 -2.90056 -11.9634 +70 4 54.3208 7.62968 35.9579 -2.73912 -6.0948 -8.85904 +71 4 1.62786 8.40831 34.848 -1.08621 1.70246 3.68663 +72 4 54.8519 10.113 38.4282 -15.3846 -1.92761 17.9785 +73 4 2.932 10.5406 34.5118 -0.192368 -3.19302 0.526177 +74 4 1.1987 12.2443 38.1226 0.692592 -32.2473 -20.0357 +75 4 2.79857 12.4271 36.2097 -23.9561 -41.0367 -3.09354 +76 1 53.0712 5.5328 37.7893 -5.57771 32.7805 23.2413 +77 2 51.973 4.62909 37.5111 5.69369 -27.8287 -42.174 +78 2 50.7933 5.44178 36.9635 6.83138 2.9595 14.8019 +79 3 50.2601 6.28483 37.7029 -2.00888 -3.43203 -15.9694 +80 4 52.7232 6.34215 38.4237 19.8206 -30.3225 -23.0649 +81 4 52.294 3.8899 36.6472 -5.7065 17.91 27.0613 +82 2 51.558 3.79481 38.7755 -4.51595 7.33433 1.21121 +83 2 50.3828 2.83682 38.5018 -9.13901 -44.4412 -29.5986 +84 2 52.8166 3.00155 39.2294 -15.7012 -7.04664 11.9409 +85 4 51.1774 4.47766 39.5861 12.1653 -0.853429 -2.8896 +86 4 50.5215 2.15128 37.5875 8.57056 17.9281 16.1392 +87 4 49.4053 3.30815 38.2892 0.50336 12.9055 3.57196 +88 4 50.1645 2.10956 39.3273 7.20165 10.7054 2.61524 +89 4 53.3305 3.56036 40.0335 2.85201 1.25263 3.90533 +90 4 53.556 2.88446 38.4204 4.77396 -6.45058 -3.13498 +91 4 52.5519 1.98529 39.6413 5.25091 8.27159 -2.68354 +92 1 50.4114 5.20625 35.6841 -20.1476 8.87025 -3.50293 +93 2 49.1688 5.73971 35.0966 -28.9774 8.99335 -1.66554 +94 2 48.0726 4.67952 35.3573 13.5632 -27.7837 -20.7653 +95 3 48.2724 3.51151 34.9309 -12.9152 20.0019 12.3092 +96 4 50.758 4.377 35.1895 1.67728 -2.63512 -1.50997 +97 4 48.8371 6.69602 35.5973 10.748 -7.18216 5.66994 +98 2 49.2038 6.04752 33.5367 10.0422 21.5226 29.5984 +99 2 47.9776 6.84135 32.9981 5.60977 17.6728 -19.5296 +100 2 48.06 7.31101 31.4919 41.3779 8.51018 8.58065 +101 2 48.2223 6.22581 30.3803 10.2277 10.7815 -8.37061 +102 1 48.1882 6.76889 29.0124 -44.0668 -20.3552 -6.98541 +103 4 49.2392 5.11894 32.9842 10.5057 -23.1259 -12.3022 +104 4 50.1653 6.62923 33.3927 -11.345 -5.02104 -10.4632 +105 4 47.825 7.77207 33.6051 2.48464 -5.23088 2.05035 +106 4 47.0343 6.2773 33.0942 -1.95432 -7.79908 6.21428 +107 4 48.9189 8.07819 31.4105 -13.7973 -19.6161 -0.159439 +108 4 47.1832 7.92091 31.2683 -17.7289 5.61577 -2.96622 +109 4 47.3306 5.536 30.4593 16.0468 -5.76301 1.4082 +110 4 49.2642 5.74618 30.4425 -24.8663 -4.45667 9.08666 +111 4 48.9827 7.28362 28.7526 29.3958 17.558 -6.10605 +112 4 47.3901 7.43056 28.8463 17.4375 -26.0151 1.0329 +113 4 48.1308 5.99149 28.2967 -4.23626 26.2635 18.8845 +114 1 46.923 5.03715 35.9679 -17.5656 23.7329 15.0201 +115 2 45.6707 4.26397 36.0383 7.41887 0.1342 36.2715 +116 2 44.9083 4.3955 34.7419 -9.99807 18.7078 -56.0122 +117 3 45.3082 5.1515 33.8118 -11.5681 -21.3087 27.1246 +118 4 46.8218 5.98238 36.4144 8.23522 -16.4135 -11.8728 +119 4 45.8989 3.17264 36.1884 2.80321 2.94058 -5.13324 +120 2 44.7401 4.70263 37.2808 -1.60464 -36.3649 -20.2774 +121 3 44.4616 6.07663 37.208 27.8602 32.4116 16.0792 +122 2 45.244 4.25605 38.6868 21.6281 49.2853 -20.5016 +123 4 43.7497 4.17807 37.1099 13.0537 7.54308 5.65065 +124 4 45.2592 6.57873 37.5303 -28.9412 -17.1189 -11.5145 +125 4 45.9129 5.11546 39.1089 -19.7485 -23.953 -1.10378 +126 4 45.8752 3.36487 38.6536 3.71139 -12.8851 -1.61893 +127 4 44.3595 4.03827 39.3021 -3.33201 1.23649 16.0156 +128 1 43.7613 3.66416 34.5997 13.2589 -16.0433 44.4251 +129 2 42.7828 3.62815 33.5465 18.9204 -1.21878 -42.6601 +130 2 41.7763 4.78741 33.7016 8.26701 -3.22526 52.4496 +131 3 41.2647 5.35582 32.7525 -2.05798 3.57411 -28.7638 +132 4 43.4932 3.04471 35.4154 4.99312 14.665 -20.8764 +133 4 43.36 3.79542 32.5266 -17.2288 -0.741434 30.8189 +134 2 42.0901 2.2209 33.4572 -3.06831 -30.079 -8.91003 +135 2 42.9343 0.899345 33.7586 6.86735 -2.69949 -8.81151 +136 2 42.2038 41.463 33.3849 1.50493 16.9918 14.9247 +137 2 44.2499 0.864187 32.9361 47.2855 12.5868 41.6398 +138 4 41.5678 2.05281 32.481 6.79941 12.0418 -2.16148 +139 4 41.2531 2.16469 34.1657 -6.29243 10.0771 8.19014 +140 4 43.198 0.869694 34.8519 -1.4112 0.953999 -4.44245 +141 4 42.8702 40.5903 33.6002 -4.10478 0.398246 -9.68788 +142 4 41.7896 41.4589 32.3582 7.27854 -3.68783 -7.38435 +143 4 41.3262 41.3063 34.0224 -6.75638 1.39507 6.42691 +144 4 44.0947 0.829251 31.8728 -5.75954 4.64229 -28.5029 +145 4 44.9396 41.8855 33.1737 -20.9549 12.1515 -1.19165 +146 4 44.9309 1.76601 33.2059 -22.5069 -20.3291 -10.4095 +147 1 41.5145 5.2236 34.9901 10.2672 4.08625 -51.0356 +148 2 40.6676 6.35891 35.268 -24.1778 -10.7223 -7.79527 +149 2 41.3691 7.72376 35.0974 2.95483 13.7574 -3.11119 +150 3 40.6975 8.75349 34.8431 -2.15612 -12.5202 3.44484 +151 4 41.8176 4.64617 35.7553 2.04542 -7.36824 24.1106 +152 4 39.8621 6.3427 34.4551 10.5786 9.41727 7.44594 +153 2 39.8405 6.1283 36.5756 19.8539 -2.67173 26.8296 +154 3 40.7601 5.89106 37.6735 -0.128972 20.3018 -14.678 +155 2 38.9248 4.89402 36.5497 -24.3083 -6.19306 -11.8519 +156 4 39.228 7.01129 36.8511 -0.372961 8.24506 -6.20484 +157 4 41.1549 6.75425 37.8536 -4.13097 -9.7211 -3.01543 +158 4 38.1722 4.94482 35.71 1.05658 9.14576 13.4136 +159 4 38.3953 4.71355 37.5213 -1.28546 9.2328 -6.30902 +160 4 39.3771 3.92967 36.3433 23.1336 -11.0543 -1.24287 +161 1 42.7302 7.8059 35.1562 3.49276 1.34371 4.78693 +162 2 43.5269 8.99303 34.9539 -8.19772 -21.7996 13.9087 +163 2 44.4646 9.39471 36.0778 41.0762 49.5413 -62.5687 +164 3 45.3993 10.2183 35.7654 -29.643 -36.0587 21.7786 +165 4 43.357 7.05719 35.4614 -7.13629 -15.5308 5.06399 +166 4 44.0803 8.92821 34.0189 14.2015 -9.60403 -10.8131 +167 4 42.9032 9.83742 34.7399 -16.6431 23.0824 1.78637 +168 1 44.28 8.95267 37.3076 -5.41717 -6.01048 56.4016 +169 2 45.1954 9.30059 38.3934 14.0544 9.09198 9.45122 +170 2 46.5736 8.71838 38.034 -4.40481 25.0392 4.24124 +171 3 46.7239 7.52665 37.7592 -2.06685 -10.8071 -7.31186 +172 4 43.4369 8.46722 37.66 -0.808029 1.80219 -13.797 +173 4 45.2932 10.4319 38.4595 -5.35026 -12.3633 -15.6489 +174 2 44.7775 8.83735 39.8303 19.1756 -23.9015 -7.23155 +175 2 45.4882 9.63492 40.9425 5.24315 -15.5914 27.8506 +176 2 45.0424 11.1143 41.0465 6.36216 -11.291 -10.339 +177 2 45.9827 11.9035 0.041605 38.3537 -2.96327 34.4916 +178 1 45.5586 13.2421 0.396463 -0.785075 15.3756 28.9492 +179 4 44.9912 7.72238 39.9953 -4.79728 17.8629 -7.78445 +180 4 43.7049 8.96345 39.9422 -22.2512 0.44531 4.07292 +181 4 46.5908 9.56019 40.8161 0.364544 3.82252 -6.52459 +182 4 45.3434 9.10335 0.0599805 -5.24686 13.9981 -23.7842 +183 4 44.0132 11.1324 41.4274 -10.2695 3.39123 6.70816 +184 4 44.9981 11.6023 40.04 1.8072 0.416607 6.15726 +185 4 47.0442 11.9436 41.5493 -17.6115 6.73335 -5.13538 +186 4 46.1824 11.4052 1.05233 -16.0491 -0.928483 -18.7699 +187 4 45.666 13.9003 41.5429 -6.15709 2.25656 -0.794581 +188 4 46.187 13.6261 1.17403 -31.6799 -14.737 -27.4943 +189 4 44.5482 13.2658 0.707841 33.0262 6.71149 -7.77427 +190 1 47.5786 9.61919 37.9975 -0.262725 18.6124 2.96873 +191 2 48.9681 9.33197 37.6414 -20.2336 1.72319 -17.1083 +192 2 49.7588 9.70622 38.88 39.5209 -76.7499 14.8721 +193 3 49.6145 10.763 39.4317 -9.44289 38.5374 13.5639 +194 4 47.4009 10.6083 38.3248 7.77058 -18.5649 -8.96176 +195 4 49.0172 8.23798 37.4216 9.46753 0.884559 0.506936 +196 2 49.3323 10.1282 36.3163 3.6714 0.82331 31.2642 +197 3 48.3563 9.85046 35.3281 -8.1318 -4.77519 -4.71381 +198 2 50.6865 9.72677 35.695 -19.0046 0.743943 -11.7808 +199 4 49.2557 11.2077 36.6021 8.67648 2.0602 -8.11811 +200 4 47.5419 10.2678 35.5977 -2.15846 0.170791 -0.678761 +201 4 50.8563 10.2671 34.7416 2.67544 8.24981 1.47477 +202 4 50.7066 8.66813 35.3754 2.1247 -7.47433 7.78713 +203 4 51.5309 9.954 36.3541 9.43429 -0.352141 7.40173 +204 1 50.5004 8.65755 39.48 -48.513 49.986 -45.0014 +205 2 51.0618 8.74392 40.7907 20.8089 -26.4742 28.5407 +206 2 52.5708 8.35776 40.7906 -32.7343 -31.0986 -30.3541 +207 3 52.9098 7.36002 40.1044 19.6712 31.5314 12.7437 +208 4 50.5882 7.8265 38.898 12.8881 -18.9119 10.2231 +209 4 50.9863 9.78895 41.141 -1.46865 8.60563 4.12328 +210 2 50.3037 7.79505 41.8358 -16.725 28.936 13.8764 +211 2 50.252 6.27959 41.4904 27.2589 15.6434 -4.64867 +212 2 48.8609 8.35011 0.225019 8.85004 14.588 -17.6069 +213 2 49.3953 5.42325 0.497373 -18.8945 7.05888 30.2377 +214 4 50.814 7.95159 0.918621 8.35305 -8.94958 -7.30269 +215 4 51.3186 5.93048 41.4774 -6.84536 -5.23847 5.64953 +216 4 49.9408 6.1608 40.4387 -8.33431 -3.05112 -5.55566 +217 4 48.166 7.96072 41.344 -1.46 7.63128 5.53427 +218 4 48.8165 9.51657 0.246026 0.467008 -30.2893 -0.065267 +219 4 48.5175 7.97406 1.21641 -4.07563 3.27994 -1.48455 +220 4 48.2983 5.58085 0.347667 5.50609 -0.627552 -5.84055 +221 4 49.5344 5.58322 1.60624 7.63779 5.91871 -13.4594 +222 4 49.5909 4.36583 0.361303 3.03099 -20.7712 -9.01704 +223 1 53.3669 9.15083 41.5136 39.5682 14.7354 5.79836 +224 2 54.8443 9.26777 41.6313 -32.7918 27.0996 3.53674 +225 2 0.372396 8.2907 0.722751 15.0567 -33.4937 20.6099 +226 3 54.8856 8.2259 1.87915 11.4238 -3.26125 -20.3466 +227 4 52.9167 9.73978 0.288924 -10.841 14.2188 11.5997 +228 4 0.25416 9.07559 40.636 9.98484 -5.7038 -17.1316 +229 2 0.351513 10.7152 0.19938 0.985642 14.1538 -10.6635 +230 3 54.4575 11.7797 41.7528 -11.3464 -18.6066 -9.73211 +231 2 1.66903 11.1049 41.4122 7.34382 -22.4378 -10.8926 +232 4 0.4803 10.8256 1.29559 2.15483 -15.9854 6.57991 +233 4 54.1789 12.1729 0.660397 -4.76608 7.18995 2.46446 +234 4 2.02372 12.0909 41.706 2.9877 17.6459 6.95349 +235 4 1.57896 11.139 40.2943 0.339955 -2.68366 6.65003 +236 4 2.50746 10.4017 41.6821 -7.50419 3.69742 -2.77337 +237 1 1.45709 7.55056 0.343709 0.783377 10.0466 -6.42735 +238 2 2.26763 6.65075 1.15078 -32.6055 -6.94536 -7.22798 +239 2 3.71498 6.9634 0.985171 49.9575 39.4499 -62.468 +240 3 4.16139 7.41516 41.7733 -24.7374 -20.1855 46.264 +241 4 1.86812 7.64334 41.3079 -3.10568 2.79536 2.39364 +242 4 2.02547 6.77359 2.21072 -7.15361 5.99983 10.1715 +243 2 1.97017 5.19949 0.677115 9.24237 23.8034 -8.70369 +244 2 0.525 4.76245 0.942436 -1.25511 -23.3688 27.6866 +245 2 0.292475 3.39123 0.300736 12.896 -21.1671 11.4366 +246 2 0.300138 4.59931 2.47443 -32.0383 1.7301 9.08136 +247 4 2.70003 4.54767 1.15632 6.2908 -16.3803 10.1517 +248 4 2.22696 5.13751 41.5068 -3.29253 -1.30987 -4.15087 +249 4 54.7656 5.47042 0.590489 -8.39992 14.3218 -15.0438 +250 4 54.2418 3.05018 0.328915 -13.2626 1.11831 3.00682 +251 4 0.884488 2.58096 0.823664 -4.50955 14.351 -5.98985 +252 4 0.593908 3.34298 41.1636 3.48003 3.40906 -16.1017 +253 4 0.952355 3.83641 2.92287 8.67303 -5.41594 2.10418 +254 4 54.195 4.2418 2.71744 29.7111 15.4634 -7.25797 +255 4 0.523461 5.5584 3.03176 -8.55492 -11.4476 -4.98522 +256 1 4.54724 6.69628 2.0028 -11.6083 -5.66543 -5.23244 +257 2 5.9708 6.78048 2.07185 29.6953 24.7002 11.5216 +258 2 6.62679 5.47067 2.57826 -56.9161 -25.5018 -48.7527 +259 3 7.55514 5.44421 3.3345 43.3901 -4.04961 27.9945 +260 4 4.11753 6.29088 2.82459 -1.31884 -6.15538 19.0144 +261 4 6.38329 6.99012 1.0501 -1.44469 -12.2628 1.79191 +262 2 6.4556 7.99651 2.97484 -29.1307 10.2847 -18.0571 +263 2 6.5028 9.34873 2.22705 -18.2939 24.7932 5.04877 +264 2 6.67525 10.5485 3.20576 -19.6949 -28.8822 -17.9407 +265 3 7.83409 10.9407 3.49149 14.4815 4.00472 5.8048 +266 3 5.6204 11.0576 3.67938 3.00737 1.04452 3.25275 +267 4 7.46376 7.72864 3.29072 15.5933 3.84479 14.8832 +268 4 5.82416 8.22265 3.87848 3.62309 -20.6245 -0.107855 +269 4 5.50278 9.55154 1.65377 27.7023 -9.35583 7.15892 +270 4 7.36204 9.37759 1.52673 -1.86837 -2.39822 -10.1271 +271 1 6.01547 4.32119 2.13096 24.825 18.8056 21.8908 +272 2 6.40109 2.94617 2.38906 -11.7575 -20.1643 -12.9237 +273 2 7.81521 2.61654 1.77783 -56.2322 2.45294 33.4207 +274 3 8.31478 3.35811 0.966233 17.239 19.087 -22.9985 +275 4 5.23593 4.40493 1.50032 -13.4301 6.78787 -12.4159 +276 4 6.42741 2.74871 3.48587 6.57798 6.02642 3.28221 +277 2 5.2086 2.00284 1.82478 32.9723 -19.5112 -16.552 +278 2 3.90497 2.10853 2.63909 4.11684 35.775 58.6384 +279 2 4.90372 2.28313 0.318971 -25.0993 -16.9694 6.10511 +280 4 5.56913 0.900136 1.85726 -4.66192 22.2662 6.6067 +281 4 4.03562 1.77943 3.74204 2.08752 -4.13501 -29.3045 +282 4 3.08076 1.58512 2.20328 -21.6762 -25.4002 -11.7361 +283 4 3.47043 3.14079 2.79739 15.5883 -5.24062 -11.8252 +284 4 4.40039 3.24668 0.146776 -5.79992 5.24774 -1.28692 +285 4 4.20501 1.47402 41.8336 8.41255 14.6516 3.66501 +286 4 5.77159 2.28177 41.569 16.6343 -1.64949 -4.80555 +287 1 8.4358 1.54559 2.27475 36.6082 -11.5601 -11.8896 +288 2 9.77403 1.09441 1.8307 -27.8835 12.6882 -14.7267 +289 2 9.60932 41.7912 0.904414 -8.95822 -4.80133 -2.77359 +290 3 8.60977 41.0717 1.04857 16.9017 -0.350054 -8.54673 +291 4 7.96937 0.851078 2.83344 -16.1443 -13.3321 15.6909 +292 4 10.1447 1.96102 1.23179 21.7718 -7.90657 2.9301 +293 2 10.6071 0.627222 3.03652 -0.441548 -3.06629 28.3632 +294 2 11.1182 1.69736 4.03374 -39.6019 -9.33118 23.345 +295 2 12.4276 2.26482 3.60541 40.3504 -3.80329 2.03759 +296 3 13.4833 1.65854 4.00477 -10.9735 16.3163 -6.96273 +297 3 12.4619 3.21875 2.76405 -4.75337 -1.04793 7.93588 +298 4 11.5429 0.117807 2.72279 -4.90068 -9.43781 -6.0473 +299 4 9.98495 41.7532 3.61242 16.0495 13.2539 -10.4034 +300 4 11.2741 1.17979 5.05068 -3.18835 9.28581 -16.8758 +301 4 10.3234 2.48031 4.23808 10.2695 -6.11036 -3.24845 +302 1 10.6563 41.4604 0.0588169 -6.20046 -15.666 -8.24155 +303 2 10.7096 40.1842 41.1911 4.64874 21.5238 9.65168 +304 2 10.6577 38.9638 0.161439 -6.67174 -46.3648 23.9629 +305 3 10.1435 37.8848 41.6696 11.1653 29.5239 15.2576 +306 4 9.85832 40.1011 40.5066 -14.3391 4.69386 -5.52668 +307 2 12.0141 40.2124 40.3653 4.26726 1.71904 -5.44169 +308 2 12.4668 41.6661 40.4777 -1.00635 15.6111 -33.0282 +309 2 11.8673 0.323303 41.767 -12.6506 -21.5702 -15.1443 +310 4 11.8545 39.873 39.2959 0.539662 6.91875 10.5587 +311 4 12.8304 39.5641 40.7546 -3.32338 -3.68521 7.20301 +312 4 12.0951 0.327352 39.5607 -0.26902 -6.73625 15.8499 +313 4 13.5766 41.7696 40.398 -3.05617 -0.547794 6.53436 +314 4 11.6542 1.3898 41.6565 2.06281 16.0871 1.21765 +315 4 12.5433 0.162045 0.691867 15.5992 2.8717 16.0141 +316 1 11.2193 39.0766 1.4086 -4.36655 24.7542 -22.059 +317 2 11.4309 38.0888 2.42328 2.01986 -2.25877 10.0578 +318 2 10.2357 37.7662 3.3374 -3.13249 5.62439 -12.9442 +319 3 10.4243 36.9709 4.25096 -6.41092 -9.96708 1.94465 +320 4 11.5904 40.0068 1.66465 -1.36758 -8.10945 4.45955 +321 4 11.6246 37.1209 1.91909 1.66244 -5.96089 -4.69733 +322 2 12.7089 38.4628 3.26447 -19.7243 1.96837 18.865 +323 3 12.593 39.7548 3.85012 -16.3579 -13.4437 -0.292868 +324 4 13.6002 38.4999 2.63657 13.9756 -7.10852 -11.694 +325 4 12.8962 37.7302 4.10036 -1.36843 4.44789 -10.4248 +326 4 11.9859 39.6657 4.60642 10.4094 13.6351 -5.41979 +327 1 9.02275 38.3618 3.12708 -24.8633 34.0603 -47.8229 +328 2 7.7797 38.1104 3.9237 -5.5143 -4.40103 -12.4219 +329 2 6.80948 37.1627 3.16843 27.134 16.5749 8.61656 +330 3 6.86683 37.0056 1.95165 6.52379 13.0808 -10.3152 +331 4 8.81363 38.9852 2.21874 13.7891 -35.0234 50.9651 +332 4 8.06628 37.5753 4.84119 7.22917 -10.5654 7.4735 +333 2 7.01568 39.4093 4.3407 2.69101 -11.9593 -14.7657 +334 2 7.81876 40.1019 5.42325 -6.79454 3.60365 -28.1432 +335 3 8.28496 41.241 5.20721 -2.75331 10.4655 -0.123769 +336 3 8.08719 39.4782 6.47272 0.652509 -5.2024 22.4807 +337 4 5.97814 39.1687 4.67547 5.82193 1.31451 7.85599 +338 4 6.83632 40.0167 3.42407 6.48365 7.00102 3.75656 +339 1 5.92582 36.4787 3.90047 -14.2639 -13.8348 21.4567 +340 2 4.95916 35.6178 3.24268 -4.4575 6.83929 8.3992 +341 2 3.83929 36.4769 2.71202 -44.4588 -49.3176 -48.5312 +342 3 3.60925 37.6169 3.05258 2.07424 26.7384 14.4764 +343 4 5.8145 36.534 4.942 7.63157 5.21975 -16.3776 +344 4 5.40617 35.1414 2.34351 4.65472 -4.22423 0.555341 +345 2 4.39718 34.509 4.16235 13.2774 -34.7614 9.16528 +346 3 3.98438 35.0519 5.39575 -10.4467 6.31908 32.28 +347 2 5.50619 33.4543 4.48033 -18.4692 -3.54598 29.0115 +348 4 3.53919 33.9402 3.74776 -4.47694 5.79242 -10.2957 +349 4 3.62452 34.3759 6.00064 11.5458 5.5573 -22.0279 +350 4 5.86065 32.9579 3.58801 8.19644 -6.15464 -22.9143 +351 4 5.08151 32.5761 5.12909 16.3877 29.7333 -11.6263 +352 4 6.39565 33.9521 4.95041 -3.85278 -8.84208 3.35803 +353 1 2.97294 35.7888 1.83357 24.6732 25.9217 25.2152 +354 2 1.71267 36.3687 1.37347 -5.03432 -5.896 10.5631 +355 2 0.744229 36.5497 2.58991 -5.24139 24.3125 -23.8477 +356 3 54.9871 37.5497 2.63122 18.6385 -17.0409 3.73872 +357 4 3.28773 34.8825 1.44268 -6.98273 2.93822 -0.272558 +358 4 1.87243 37.434 1.07109 4.86902 -3.5162 -5.74397 +359 2 1.111 35.5523 0.154125 -16.9781 -2.34719 28.1775 +360 2 1.71191 35.9998 40.7076 5.75717 0.931703 -28.4951 +361 2 54.5365 35.7134 0.116808 -8.16561 0.919103 1.38616 +362 2 3.27145 35.9095 40.6267 -43.0781 7.09941 -3.6072 +363 4 1.31237 34.4411 0.36052 2.96229 18.9121 -10.1464 +364 4 1.38444 37.0145 40.3207 4.07875 -5.77915 19.4423 +365 4 1.27316 35.3433 39.9124 8.37762 -5.40948 6.65521 +366 4 54.0772 35.0942 41.2103 3.74338 3.48587 4.89864 +367 4 54.2123 36.7722 41.8688 5.5832 -2.69651 -3.34762 +368 4 54.0157 35.4055 1.08169 10.5414 -0.491815 -14.4897 +369 4 3.61367 34.902 40.8802 7.83264 -12.2373 1.45006 +370 4 3.69229 36.6315 41.3343 12.2091 5.94613 6.19684 +371 4 3.59275 36.1798 39.604 6.95495 -3.49191 -4.00644 +372 1 0.74604 35.6172 3.54454 -3.3388 -35.9018 49.598 +373 2 0.0112331 35.6552 4.85892 21.257 7.22823 -39.6883 +374 2 0.198256 37.0471 5.48367 -2.86302 -31.8341 -17.2866 +375 3 54.1912 37.6952 5.75353 -1.48181 26.0574 3.92406 +376 4 1.16676 34.6739 3.4098 -0.571923 12.3969 -9.16993 +377 4 53.9399 35.5324 4.59955 -13.6683 1.62606 4.36563 +378 2 0.479844 34.4894 5.77304 -8.63544 -0.437888 22.4632 +379 2 54.7769 34.3327 7.14546 -8.87326 -9.27459 2.92058 +380 2 0.0146857 35.4787 8.12524 6.60033 -5.57439 2.5368 +381 3 54.0952 36.3427 8.3329 8.35004 -1.43527 5.86114 +382 3 1.11008 35.478 8.75909 4.47833 6.11486 1.03148 +383 4 1.57132 34.5563 5.98457 -0.698959 1.91632 -4.64924 +384 4 0.309529 33.5134 5.28188 2.4365 -3.54209 -11.468 +385 4 0.179249 33.4003 7.64738 0.479338 5.67065 -5.66203 +386 4 53.6776 34.105 7.04833 9.83525 6.91672 -4.06122 +387 1 1.48459 37.3964 5.63734 26.9411 18.0032 -4.38534 +388 2 2.00708 38.6625 6.18614 -17.3218 -26.0277 -29.9987 +389 2 1.56827 39.8885 5.33406 1.07082 -15.6319 68.2882 +390 3 1.08143 40.8395 5.94485 1.04665 3.34176 -10.6171 +391 4 2.21263 36.6994 5.39095 -3.57075 5.04293 0.958686 +392 4 1.48422 38.7142 7.17744 15.2971 12.5748 0.959573 +393 2 3.55969 38.5843 6.25222 7.32448 -15.8569 15.0135 +394 2 4.09689 39.7132 7.09894 -5.63198 1.92213 9.01267 +395 3 4.56636 40.7179 6.56654 0.030916 3.04529 -1.1693 +396 1 3.96361 39.556 8.43894 1.042 12.9555 16.4237 +397 4 4.05831 38.7157 5.24953 -10.2579 -5.90723 4.64011 +398 4 3.91694 37.5778 6.70114 -5.07122 23.1073 -10.2752 +399 4 3.40266 38.7698 8.86734 10.6722 14.2638 -7.23316 +400 4 4.31989 40.3411 9.06061 -10.7144 -22.9188 -14.0526 +401 1 1.60475 39.819 4.02334 -43.55 39.5967 -43.6917 +402 2 0.959151 40.8062 3.12947 9.93922 10.0651 20.657 +403 2 54.4776 41.0208 3.48285 -52.4492 -13.4217 15.5726 +404 3 53.9715 0.237442 3.65017 19.1527 -10.2385 2.60078 +405 4 2.04263 39.1125 3.49268 25.4866 -43.7222 -11.6271 +406 4 1.43469 41.7946 3.36052 -1.16639 -0.650149 -3.04645 +407 2 1.13376 40.5205 1.61049 -4.45578 -2.70165 -27.9407 +408 2 0.490261 41.6149 0.695896 4.53105 0.20202 29.6943 +409 2 2.64975 40.4484 1.23692 -3.92583 -1.39436 -18.6979 +410 4 0.60342 39.5705 1.32385 8.41785 -1.89228 7.96418 +411 4 54.3692 41.6195 0.82936 4.25856 9.6792 3.81375 +412 4 0.622371 41.4492 41.5424 7.52435 -6.48816 -19.7965 +413 4 0.973053 0.688907 0.936332 -12.1275 -4.49455 -2.44597 +414 4 2.86969 40.4983 0.122209 -12.9804 -12.5133 18.6513 +415 4 3.14027 39.5547 1.69882 2.20392 3.04031 -6.93039 +416 4 3.17994 41.3387 1.56797 8.55742 10.8937 16.8775 +417 1 53.6665 39.902 3.64569 3.02926 35.878 11.6697 +418 2 52.2466 39.9148 4.06102 19.2385 27.0707 -26.8098 +419 2 52.053 40.5369 5.44904 5.36155 -11.3244 -6.70427 +420 3 51.0493 41.2119 5.6977 3.00195 1.8183 -1.23959 +421 4 54.0359 38.9941 3.4462 12.1828 -26.316 -3.91411 +422 4 51.7731 40.6655 3.34079 -4.82064 -14.7659 11.8755 +423 2 51.582 38.5149 3.95778 -5.61462 -20.1546 -9.91009 +424 2 51.4355 37.9559 2.49174 21.0062 -12.2216 22.8132 +425 2 51.0144 36.4629 2.37849 -12.7289 -13.0945 -11.3158 +426 2 50.8009 35.9817 0.883468 22.3055 45.8074 13.5352 +427 1 50.1864 34.6873 0.684667 2.36531 28.1154 -10.556 +428 4 50.5344 38.5648 4.38466 13.3699 -2.49694 2.21203 +429 4 52.2198 37.7725 4.53757 -13.8611 9.51826 -2.20414 +430 4 52.4594 37.9738 2.01537 -10.7122 14.3169 -4.94324 +431 4 50.6781 38.6054 2.01085 7.27079 0.282464 -15.5314 +432 4 50.0599 36.3043 2.92579 -2.19776 -0.350037 2.41174 +433 4 51.7586 35.7685 2.83822 0.223715 4.6579 4.31096 +434 4 51.8274 35.9658 0.402852 -15.0801 -2.53131 0.358002 +435 4 50.2142 36.8299 0.38331 4.02889 -26.7998 -2.47013 +436 4 50.6312 33.9821 1.2741 -7.74727 -6.99272 -14.4028 +437 4 50.1255 34.5169 41.5875 17.6482 -15.4813 7.31014 +438 4 49.2229 34.7469 0.909632 -22.6621 -5.40937 19.0501 +439 1 53.014 40.2496 6.3528 -7.33511 22.7823 24.6419 +440 2 53.0995 40.7279 7.73814 -49.8191 -29.044 -3.24915 +441 2 53.1557 0.329785 7.7965 36.8238 12.814 -39.8954 +442 3 52.5287 0.997511 8.60414 -15.9304 4.02299 13.5617 +443 4 53.7341 39.5741 6.15629 12.7417 -17.108 -13.0125 +444 4 52.0658 40.401 8.2322 35.0205 13.5384 -7.46142 +445 2 54.2887 40.0362 8.44194 -31.1952 -6.28028 37.9979 +446 4 54.3393 40.3597 9.51814 11.9598 15.0179 -15.3163 +447 4 0.207826 40.1934 7.85611 17.4499 5.7482 6.56468 +448 4 54.1321 38.9464 8.61757 0.233079 -2.0185 -17.8759 +449 1 53.9798 0.938968 6.8679 -0.195991 -19.5991 -5.8991 +450 2 54.0539 2.3703 6.69095 -13.0728 33.3033 12.6105 +451 2 52.7411 3.03405 6.19669 -13.7918 -57.342 -43.9621 +452 3 52.3429 4.1409 6.51048 0.805927 21.8583 24.6591 +453 4 54.6966 0.402301 6.30051 -22.9471 7.504 14.9388 +454 4 54.1387 2.85352 7.70963 6.90446 -7.48262 -5.16091 +455 2 0.230181 2.82991 5.77971 -8.39605 37.5401 -18.7849 +456 2 1.62806 2.36187 6.13631 43.8101 -17.859 13.5365 +457 2 2.01439 2.63812 7.6434 4.44409 -15.8917 -34.667 +458 2 3.251 1.82053 8.03886 10.3698 -25.435 21.3536 +459 1 3.78609 2.13458 9.37971 -1.03569 -21.7613 -70.4054 +460 4 0.236987 4.00662 5.72725 -0.841737 -32.3075 1.88093 +461 4 55.0233 2.47547 4.72977 -1.92078 4.0191 4.58104 +462 4 2.43886 2.84427 5.52141 -13.7997 6.98566 -1.14785 +463 4 1.8001 1.26942 5.8525 -13.1218 12.7308 11.199 +464 4 1.17734 2.2629 8.25415 -4.76662 9.03037 15.6753 +465 4 2.26439 3.72233 7.77766 -11.2971 -1.006 3.39024 +466 4 4.0605 1.91272 7.29579 6.96563 5.43042 -1.59904 +467 4 3.03028 0.709673 8.06144 -4.99399 12.6268 -3.20223 +468 4 3.89697 1.2978 9.90866 2.2165 -13.9672 17.3419 +469 4 3.11983 2.70535 9.83652 -2.18207 25.7622 26.4666 +470 4 4.71792 2.51816 9.23842 -3.78155 13.4581 18.6473 +471 1 52.0021 2.30339 5.27929 12.8772 20.7449 44.6796 +472 2 50.6928 2.72834 4.84618 -13.8318 -0.832969 -24.58 +473 2 49.579 2.58092 5.91693 0.565718 25.7533 -2.22664 +474 3 48.7752 3.51298 6.10069 9.60089 -13.9081 0.0850852 +475 4 52.4111 1.47967 4.84803 3.54375 -13.752 -6.04623 +476 4 50.7183 3.81521 4.5849 2.62435 0.742467 8.46338 +477 2 50.3339 2.0499 3.47904 12.4361 -26.7668 8.24264 +478 2 51.3981 2.34325 2.36407 -25.9391 22.844 -14.5031 +479 2 48.9153 2.37958 2.98651 -2.89914 40.9383 9.35249 +480 2 51.1891 1.41918 1.15407 38.5806 -15.4927 -30.3188 +481 4 50.4158 0.92469 3.65006 -8.90797 13.02 4.48026 +482 4 52.4055 2.20648 2.74929 18.7984 -5.45377 5.09466 +483 4 51.3666 3.42411 2.00589 -1.76359 -13.5005 7.53435 +484 4 48.1353 2.36077 3.79579 2.75746 -16.6411 -10.078 +485 4 48.6799 1.76326 2.11438 -14.9792 -11.0957 -5.84075 +486 4 48.8325 3.45193 2.63807 7.50371 -11.7896 -0.401559 +487 4 52.1004 1.43799 0.414216 -21.3416 1.39174 26.2203 +488 4 50.3409 1.68288 0.503068 -10.2032 3.93981 2.99084 +489 4 51.0565 0.33979 1.46483 1.72575 11.8892 -3.22767 +490 1 49.5807 1.53255 6.75244 19.5889 -24.3514 7.76629 +491 2 48.7262 1.39688 7.92951 3.12598 20.2674 -1.73108 +492 2 48.8873 2.63773 8.86406 -22.8968 -16.6402 -5.42224 +493 3 47.8891 3.05472 9.45614 -0.472007 6.27789 -5.95623 +494 4 50.2352 0.731103 6.58688 -10.8709 15.7502 1.66713 +495 4 47.6402 1.39986 7.60999 11.2933 -0.131061 -1.07735 +496 2 49.0614 0.0990051 8.70607 -29.9824 -25.1823 -11.7347 +497 2 48.2869 41.7602 10.01 13.4599 -0.122667 29.7563 +498 2 46.7828 0.0292377 10.0132 -0.929007 -24.4408 -23.1824 +499 3 46.2118 0.52149 10.9702 -12.9016 15.2185 13.9881 +500 1 46.1401 41.3429 8.96595 27.5879 22.2376 34.4467 +501 4 50.107 0.108866 8.97457 27.7162 -1.73681 3.74735 +502 4 48.8999 41.0818 8.03917 5.36927 20.2302 10.0129 +503 4 48.7183 0.460982 10.852 -8.35522 8.57003 -12.646 +504 4 48.4869 40.755 10.454 -1.65554 -4.90235 -14.5783 +505 4 46.6392 40.8985 8.22302 16.4703 -11.2583 -22.7525 +506 4 45.1487 41.2958 8.97726 -40.9601 -1.33251 0.190018 +507 1 50.0995 3.17318 9.05078 3.95851 -0.0485648 -3.79593 +508 2 50.3325 4.25644 9.97415 17.5873 21.0859 -2.62556 +509 2 49.9752 5.63804 9.37548 -18.0954 -29.5198 29.938 +510 3 49.379 6.45094 10.0988 9.73071 -4.74536 -2.58342 +511 4 50.9107 2.76055 8.59957 11.9693 -5.38147 -4.75744 +512 4 49.6509 4.09994 10.8399 -6.9467 2.38538 1.23714 +513 2 51.7744 4.26209 10.561 -12.6039 -21.2869 -0.279481 +514 2 51.8614 5.17465 11.7883 77.4573 -1.34868 -55.222 +515 3 50.9415 5.19238 12.5756 -62.6641 4.37367 45.7089 +516 3 52.9385 5.83334 11.9521 -15.5069 -3.45829 -0.856418 +517 4 52.5513 4.49045 9.80335 -1.41111 7.91559 -3.33271 +518 4 51.9847 3.17606 10.8252 3.56611 15.7947 8.37571 +519 1 50.1134 5.83384 8.05697 5.03044 -3.38183 -24.9476 +520 2 49.6949 7.07302 7.45907 -6.39224 21.6045 -14.6025 +521 2 48.2404 7.19765 6.96855 9.41443 -40.5535 -11.5325 +522 3 47.5994 8.23003 7.09737 -2.60339 17.4007 5.13595 +523 4 50.5903 5.18529 7.39903 -4.72806 0.48988 13.3104 +524 4 49.6568 7.79446 8.28532 6.84483 14.8177 6.93296 +525 2 50.7045 7.63108 6.39006 -19.8247 -9.47824 8.02755 +526 2 50.6996 6.84785 5.08902 -10.629 2.31661 -15.1243 +527 2 51.6586 7.26626 3.9659 -11.3496 43.5825 3.95364 +528 2 53.1317 7.00105 4.2557 32.8208 18.7244 -18.8206 +529 1 53.7683 7.95578 5.14747 -10.6729 7.59108 -11.9454 +530 4 51.7028 7.64661 6.81348 16.7201 -1.45014 11.0251 +531 4 50.4708 8.68128 6.19684 -5.34256 14.1207 -5.41714 +532 4 49.6713 6.8702 4.6668 -0.861277 1.74329 -1.61352 +533 4 50.8688 5.79892 5.31654 5.28855 -19.0543 2.54637 +534 4 51.4741 8.35024 3.65396 8.42695 -12.5098 16.2485 +535 4 51.3565 6.79125 3.04708 -1.5826 -26.0582 -19.3792 +536 4 53.7673 7.0998 3.31183 -20.6632 -9.77681 9.39502 +537 4 53.2972 5.98514 4.64126 3.7215 -8.75629 2.11801 +538 4 53.3251 8.87081 5.17658 4.71004 0.103302 -2.74719 +539 4 54.7439 8.12131 4.95956 10.0262 2.1061 -7.58392 +540 4 53.7752 7.60869 6.06781 -3.05466 -8.65204 35.212 +541 1 47.7159 6.1092 6.3306 31.3529 14.3598 14.0351 +542 2 46.4076 6.11425 5.7591 -25.7668 -19.0326 -13.8071 +543 2 45.4013 5.23171 6.47844 56.1675 -11.9112 16.6864 +544 3 44.23 5.34684 6.24133 -49.2229 2.39302 -4.99484 +545 4 48.3398 5.28969 6.15889 -17.2258 10.451 -1.21207 +546 4 45.9358 7.11624 5.83656 4.3919 7.44058 4.79016 +547 2 46.401 5.6982 4.25555 12.45 -16.5042 -24.1702 +548 2 46.8608 6.82251 3.28226 -4.83626 -15.1342 -13.4955 +549 2 46.0803 8.13881 3.30599 -14.5444 -4.79224 -13.1752 +550 3 44.9716 8.27119 2.67975 10.7775 -8.64163 7.28309 +551 3 46.5691 9.08454 3.95876 4.86602 16.815 8.62941 +552 4 45.3845 5.39013 3.90204 -1.72737 6.76951 8.44594 +553 4 47.0179 4.72632 4.06618 -9.2699 26.8442 8.77601 +554 4 46.8747 6.40942 2.20799 2.04532 8.89503 18.2744 +555 4 47.9008 7.08537 3.56457 7.18737 -1.18981 -5.53646 +556 1 45.8799 4.29222 7.33829 -37.7514 2.20406 -4.61566 +557 2 44.9987 3.41141 8.06424 -3.99299 1.7641 -5.76947 +558 2 44.3276 2.33248 7.21969 -45.1266 -42.7281 27.6017 +559 3 43.411 1.613 7.73718 25.6836 24.6852 -13.962 +560 4 46.8488 4.10168 7.49502 31.0353 -1.43619 1.82022 +561 4 45.5349 2.87862 8.87403 3.80662 2.65181 2.49747 +562 4 44.2009 4.01738 8.56522 2.51171 -3.43938 -1.53795 +563 1 44.7359 2.05713 5.97006 1.92732 3.23614 21.462 +564 2 44.1948 0.978467 5.13766 -26.7101 17.135 -13.9432 +565 2 44.8486 41.5478 5.5025 3.41127 -20.6454 16.5554 +566 3 46.0871 41.4431 5.57675 -14.0525 11.0231 2.35631 +567 4 45.5581 2.59183 5.73006 15.6975 -3.64086 -27.3416 +568 4 43.0338 0.980574 5.28193 28.569 -9.56263 1.83686 +569 2 44.4255 1.37435 3.62453 6.02041 -5.1027 -4.41971 +570 2 43.5303 2.62118 3.29791 4.64703 16.7196 -23.7169 +571 2 44.2051 0.148173 2.67978 -29.1583 2.83252 11.5038 +572 2 43.5747 3.10962 1.83395 1.21002 2.08355 -6.515 +573 4 45.4937 1.66977 3.44724 -0.165314 0.952935 9.41179 +574 4 43.8006 3.52551 3.92139 -2.56937 -12.5949 1.07415 +575 4 42.4611 2.43664 3.46298 -10.2855 -9.14552 12.9963 +576 4 44.5119 0.377143 1.64896 8.27723 -0.881131 -7.54742 +577 4 43.1044 41.7625 2.59144 16.8524 3.81389 6.96191 +578 4 44.7846 41.171 3.05101 -3.46686 1.83863 -12.0461 +579 4 44.5392 3.56167 1.57116 9.55733 8.13116 4.62467 +580 4 42.7809 3.86627 1.57982 6.14378 -4.69974 7.81616 +581 4 43.4757 2.31615 1.08375 -8.22918 -11.6964 -1.57482 +582 1 44.0839 40.4233 5.76821 21.932 -1.5334 -8.86254 +583 2 44.7424 39.1674 6.24443 -3.28027 29.5462 -2.23354 +584 2 45.6232 38.4648 5.15467 16.5957 -3.17533 31.1682 +585 3 45.1655 38.1269 4.0769 -9.06079 2.14789 -9.97198 +586 4 45.3594 39.5074 7.13461 -7.15079 -15.4686 -7.49065 +587 2 43.5266 38.3049 6.70081 12.2837 2.36218 -7.01546 +588 2 42.3912 38.8204 5.83129 -5.25874 0.19697 14.2242 +589 2 42.6515 40.3318 5.90174 -25.8883 17.7161 37.6601 +590 4 43.2615 38.5482 7.76954 6.63706 -13.879 -3.94164 +591 4 43.7406 37.2122 6.50504 -6.24398 7.50926 12.4246 +592 4 41.3856 38.4747 6.1895 5.24712 7.09666 -1.13826 +593 4 42.5101 38.4102 4.83081 -0.0162975 -1.57753 -20.806 +594 4 42.2783 40.7857 6.94925 18.7272 -16.9878 -38.5107 +595 4 42.0764 40.8825 5.13323 2.00122 -0.967094 -8.03005 +596 1 46.8623 38.0021 5.57674 -15.3549 -23.0767 -9.82664 +597 2 47.7161 37.0187 4.84527 -3.88045 42.2808 23.2471 +598 2 47.0384 35.8723 4.15029 10.1677 -9.37304 -39.3599 +599 3 47.4551 35.4743 3.0324 -9.4669 19.846 29.5852 +600 4 48.2252 37.6386 4.0698 7.54977 -11.2433 -2.33648 +601 2 48.6452 36.5035 5.99482 -10.0312 13.1223 -5.95218 +602 2 48.8959 37.7819 6.80046 -4.41071 -5.72741 24.5975 +603 2 47.4918 38.4151 6.80561 23.284 1.3706 -4.72721 +604 4 49.5844 36.0861 5.59811 5.91725 -9.04521 -0.913385 +605 4 48.1158 35.748 6.64071 6.83063 -0.71303 -5.46675 +606 4 49.6383 38.4449 6.34864 7.02588 7.83512 -10.7506 +607 4 49.3019 37.5753 7.85532 -11.9914 1.76609 -18.7023 +608 4 47.544 39.5162 6.85821 3.72706 6.34433 1.60956 +609 4 46.9486 38.0654 7.68542 -11.5693 -5.06488 12.3189 +610 1 46.0019 35.318 4.78064 -26.4221 -3.88232 27.7903 +611 2 45.3025 34.13 4.26579 26.8092 19.3149 11.5505 +612 2 44.4585 34.46 3.02929 16.6723 1.23881 35.6677 +613 3 44.3932 33.6565 2.12406 -6.96945 -13.3218 -23.6344 +614 4 45.6895 35.6839 5.72645 6.17072 -11.3773 -21.4598 +615 4 46.1371 33.4525 3.9443 -9.57056 -4.48549 -9.01935 +616 2 44.5851 33.4333 5.41517 7.28023 -34.3989 -9.31284 +617 2 43.896 32.1478 4.95943 -2.5072 53.7563 23.2534 +618 3 42.6929 32.0377 5.28407 -11.6877 -17.8688 -5.68187 +619 3 44.6212 31.2997 4.42805 15.8429 -32.9345 -13.4225 +620 4 43.8908 34.1037 5.87793 -28.8167 18.0933 10.1447 +621 4 45.2673 33.1449 6.25678 1.67129 3.14432 -6.05002 +622 1 43.9425 35.6996 2.93756 -0.354949 -32.7532 -51.8723 +623 2 43.3733 36.2033 1.70184 -38.6892 -13.1006 14.7431 +624 2 44.3694 36.8017 0.73913 15.0439 4.82349 -39.1461 +625 3 44.0609 36.9601 41.4463 -0.757384 -5.0254 19.6545 +626 4 44.0082 36.3398 3.67638 4.88567 37.3717 42.7902 +627 4 42.8639 35.3314 1.17484 15.8753 7.76257 0.915116 +628 2 42.1931 37.1947 1.98861 35.687 20.598 -23.7763 +629 2 41.116 36.6037 2.88066 -6.28281 10.7168 27.7809 +630 2 39.8788 37.4748 2.97821 -20.6793 -12.2331 -39.8799 +631 3 39.5744 38.0012 4.02693 -4.5695 14.1805 28.3661 +632 1 39.0796 37.534 1.86047 23.989 -9.69865 9.57867 +633 4 41.7899 37.5369 1.00167 -6.59533 -6.76427 4.06671 +634 4 42.6371 38.1477 2.39011 -7.96796 -7.2267 7.32793 +635 4 41.4745 36.4913 3.95075 -0.75248 -0.913082 -13.6466 +636 4 40.7949 35.61 2.55083 -3.16107 -12.1939 -5.02302 +637 4 39.3636 37.1043 0.951835 -4.89499 3.13933 11.6446 +638 4 38.1602 37.9899 1.92801 1.07188 2.17452 -2.18356 +639 1 45.5977 37.1878 1.1702 -15.0402 3.91697 -26.2999 +640 2 46.6124 37.7593 0.269692 0.961344 -25.1749 -6.20454 +641 2 47.1251 36.6298 41.227 -15.6894 27.1972 18.7996 +642 3 47.6617 35.6605 41.7393 11.2436 -21.3221 -9.23089 +643 4 45.7953 37.0706 2.14421 15.4189 2.49224 25.3654 +644 4 46.1246 38.4981 41.5406 -7.74237 14.7139 -7.84953 +645 2 47.8075 38.4099 1.03092 10.1012 15.6193 -18.1996 +646 2 47.4246 39.6903 1.82563 -12.4684 -22.6418 23.6998 +647 2 48.6005 40.4099 2.51691 -17.3417 -7.9082 6.23218 +648 3 49.6876 40.5582 1.97833 4.99301 -0.872474 -9.60266 +649 1 48.339 40.8761 3.75079 34.2245 13.1834 24.2049 +650 4 48.6123 38.7237 0.293834 -9.9427 -4.45455 6.13719 +651 4 48.2879 37.6501 1.66455 2.7768 -3.8165 9.90104 +652 4 46.6323 39.34 2.60232 21.0344 18.1725 -15.5096 +653 4 46.9544 40.4315 1.1644 -6.65764 6.44375 -5.56957 +654 4 47.4103 40.9551 4.17425 -6.86232 -2.61251 -1.04516 +655 4 49.1568 41.2536 4.3255 -23.3959 -10.5461 -18.532 +656 1 47.0132 36.8194 39.8944 4.79393 -10.5252 -5.84263 +657 2 47.6604 36.043 38.8342 19.1375 -30.0942 8.85154 +658 2 48.4687 37.0132 37.9763 6.82075 18.1877 -22.3602 +659 3 47.9595 37.6039 37.0009 8.77071 -9.81154 18.2462 +660 4 46.405 37.5569 39.5258 -2.34297 5.9549 -2.23138 +661 4 48.4229 35.2731 39.2798 -19.3933 25.0679 -4.92238 +662 2 46.6775 35.1997 37.9517 0.490197 24.678 -10.7229 +663 2 46.0672 34.0096 38.7198 -38.9175 -0.700818 10.3629 +664 2 46.8744 32.685 38.9073 -3.26917 9.79703 -36.9848 +665 1 47.7628 32.6295 40.0786 -15.9706 28.2316 14.6984 +666 2 48.51 31.5331 40.3435 -4.63001 14.745 41.8738 +667 1 48.7312 30.5422 39.5064 -7.34995 -4.23697 -9.55446 +668 1 48.9018 31.3819 41.635 -19.9532 28.2508 -37.0556 +669 4 47.1729 34.8887 37.0027 6.80802 -10.5296 7.48075 +670 4 45.9076 35.9114 37.5121 1.10402 -9.8189 16.5264 +671 4 45.0997 33.7597 38.1755 17.1722 -3.36537 -3.11703 +672 4 45.6001 34.3514 39.6854 13.8349 -0.884929 -1.62484 +673 4 47.4022 32.4647 37.9216 2.87405 7.70981 18.3952 +674 4 46.1271 31.862 38.9206 0.553217 -4.0431 12.8995 +675 4 47.6279 33.4362 40.8042 9.43822 -37.2826 -24.9694 +676 4 48.3342 30.5657 38.5603 0.826291 -3.97588 -2.82687 +677 4 49.185 29.675 39.7859 6.04467 -9.07236 4.91997 +678 4 48.5432 32.0104 0.443983 -2.47374 7.53927 7.97734 +679 4 49.3442 30.5519 41.958 17.8055 -32.7958 11.0172 +680 1 49.7507 37.2761 38.36 -27.9891 3.94923 -10.3626 +681 2 50.6372 38.1716 37.6465 6.90802 9.01894 -16.7299 +682 2 51.1009 37.4739 36.3314 6.00851 -0.000986305 0.302592 +683 3 51.4496 36.2941 36.3505 -3.04594 -4.29189 2.8804 +684 4 50.1774 36.6397 39.0138 14.1864 -12.0724 14.4781 +685 4 50.0595 39.0583 37.2837 -1.51256 1.6517 8.14679 +686 2 51.8464 38.6091 38.5553 2.49074 0.426256 -22.3009 +687 2 51.5192 39.49 39.8069 -13.5557 -5.73698 -8.16935 +688 2 52.7888 39.6608 40.6664 -21 22.821 44.9745 +689 2 51.0354 40.8913 39.3667 -19.684 19.0705 -14.0846 +690 4 52.5817 39.1556 37.8894 -7.88883 -2.40182 8.97054 +691 4 52.3725 37.6699 38.8321 2.26719 1.04002 8.03718 +692 4 50.6848 39.0041 40.3963 9.50705 2.70236 -0.692257 +693 4 52.9505 38.8088 41.3668 0.716139 -3.31122 -6.89789 +694 4 52.7117 40.5855 41.3722 -1.5977 -23.2904 -18.3054 +695 4 53.6872 39.819 40.0903 21.6097 1.4026 -14.7648 +696 4 51.7777 41.4333 38.7338 5.73144 0.910017 10.7761 +697 4 50.6933 41.5309 40.2327 12.7628 -5.43827 -4.45399 +698 4 50.1361 40.9136 38.7005 3.06807 -14.6998 5.44273 +699 1 51.1637 38.2069 35.1833 -8.65277 46.2898 44.1617 +700 2 51.553 37.7419 33.8846 1.56046 15.8517 -26.9219 +701 2 52.7972 38.5563 33.3946 6.24297 -42.3048 -4.64985 +702 3 52.8896 39.7642 33.5814 -6.435 17.9384 2.35192 +703 4 50.9569 39.2647 35.262 8.21378 -41.2603 -12.3383 +704 4 51.8027 36.6701 33.8819 4.46523 -10.0245 6.73196 +705 2 50.2986 37.9511 32.9329 -9.17145 -5.64023 18.3882 +706 2 49.0629 37.0889 33.4059 8.5101 -2.50878 -15.0431 +707 2 50.6601 37.6697 31.4816 -9.00198 -6.28682 -34.5666 +708 2 49.2037 35.5513 33.2317 13.0867 -6.63955 11.9256 +709 4 49.9372 39.0006 33.0238 8.27291 6.69816 -3.39278 +710 4 48.1686 37.4323 32.8001 8.11156 -5.69031 9.58675 +711 4 48.8477 37.3684 34.464 -5.28515 -5.82898 -0.156702 +712 4 49.7508 37.5287 30.8047 12.011 -0.0430796 16.0089 +713 4 51.2928 36.7446 31.376 -4.11156 8.47591 0.32382 +714 4 51.1768 38.5507 31.0175 4.51478 -6.96789 5.36543 +715 4 50.1453 35.1216 33.7014 -11.0082 12.206 -5.4516 +716 4 49.2178 35.23 32.1578 -3.59036 3.22922 4.55632 +717 4 48.3665 35.0295 33.7638 0.68062 2.42879 -7.65558 +718 1 53.772 37.8505 32.7005 11.9802 38.3584 -9.99311 +719 2 54.8892 38.4918 31.9453 -18.9337 33.3604 36.4373 +720 2 0.0457823 37.9282 30.5422 -8.24024 2.92716 -24.5162 +721 3 0.594264 36.8423 30.3259 -11.3073 1.50903 5.31397 +722 4 53.7906 36.8495 32.616 -6.44893 -30.0966 2.1434 +723 4 54.5933 39.6185 31.9763 4.67753 -27.1194 -20.6963 +724 2 1.30394 38.4484 32.6241 4.82921 -5.73508 14.5601 +725 2 2.2605 39.423 31.9346 -38.1373 19.2777 23.8899 +726 2 1.83713 40.7771 31.9484 17.1926 2.24265 -1.86924 +727 2 3.4991 39.1266 31.4137 44.2785 -3.28979 -22.8275 +728 2 2.64242 41.8019 31.4282 -29.5168 1.86603 13.0701 +729 2 4.3212 40.1796 30.8558 3.27898 -39.2743 8.81887 +730 2 3.87185 41.4777 30.8782 6.24363 43.3598 -8.15054 +731 4 1.73925 37.4095 32.5315 -6.00214 7.91305 5.68876 +732 4 1.22265 38.7505 33.7444 5.52003 -9.57077 -28.715 +733 4 0.900292 41.0813 32.4345 -2.25415 1.01323 1.36593 +734 4 3.85804 38.0586 31.4239 -1.87041 17.6471 -1.97414 +735 4 2.21075 0.929728 31.5263 16.6224 -11.4708 -8.14622 +736 4 5.34427 40.0148 30.4252 -14.7168 -7.47964 5.81345 +737 4 4.49601 0.410438 30.4759 -4.95559 -13.7664 3.94973 +738 1 54.5157 38.6773 29.5249 -27.0888 35.6462 7.20647 +739 2 54.4663 38.361 28.1069 5.2815 -2.56059 -27.0064 +740 2 53.8105 37.007 27.8285 4.1142 -30.4598 -15.4676 +741 3 54.2925 36.1623 27.0158 -8.84 24.3654 24.6709 +742 4 54.0165 39.6075 29.7175 18.6271 -30.7219 2.56864 +743 4 53.83 39.1099 27.5328 0.819814 -7.88342 20.1611 +744 2 0.845681 38.4599 27.4009 -3.37868 13.1124 0.920574 +745 4 1.3644 39.4179 27.7359 0.635395 -16.0183 -8.53916 +746 4 0.720089 38.4757 26.2839 -0.330424 7.67272 7.0695 +747 4 1.43916 37.5478 27.5772 11.0328 -1.07232 10.5421 +748 1 52.6562 36.7643 28.4919 4.43857 42.1876 29.7882 +749 2 51.8688 35.5726 28.5678 11.3762 10.3615 -9.24037 +750 2 52.1836 34.677 29.7554 -56.6515 -45.7393 26.8579 +751 3 51.2796 33.8674 30.1477 33.9368 21.5747 -13.7315 +752 4 52.2409 37.5914 29.034 7.3769 -32.5773 -16.326 +753 4 50.8037 35.9045 28.6197 0.824464 -11.9292 4.40922 +754 4 51.9818 34.9789 27.6186 -1.74208 2.17118 9.08886 +755 1 53.386 34.609 30.3327 15.9463 0.295407 3.2668 +756 2 53.8702 33.5918 31.2906 -5.336 7.3854 -1.97925 +757 2 53.2724 33.784 32.6972 3.62039 -3.18208 -20.5224 +758 3 53.318 34.8834 33.2435 -3.37109 6.20646 2.08258 +759 4 54.0584 35.341 30.1321 12.3398 9.17802 -3.54281 +760 4 53.5469 32.5903 30.928 0.510164 -2.93777 -2.78072 +761 2 0.450375 33.6574 31.3834 -19.8167 20.6669 9.28695 +762 2 1.1189 33.1041 30.1021 -5.33927 -7.82927 4.13606 +763 2 2.62926 33.3565 30.0201 27.5042 -3.46073 -5.185 +764 2 3.52676 32.4236 30.898 -7.76336 10.6891 3.26174 +765 1 4.93921 32.7908 30.8651 -15.3408 -23.1293 6.29736 +766 4 0.715906 33.1135 32.3077 13.219 -7.49284 0.339296 +767 4 0.711888 34.7596 31.5921 3.25804 -21.2431 -6.20467 +768 4 0.610971 33.6189 29.2485 6.53106 -4.93764 -4.86032 +769 4 0.94328 31.9817 29.9891 -3.372 16.4508 0.497364 +770 4 2.92569 34.3879 30.2717 -10.3735 11.8265 3.32189 +771 4 2.96748 33.277 28.9434 -5.36763 -4.46501 9.75656 +772 4 3.3856 31.3899 30.5364 6.91643 -9.08032 2.48396 +773 4 3.23325 32.4634 31.9813 -4.58699 -1.94284 -9.93441 +774 4 5.35439 32.7181 29.9584 6.30767 5.94328 -10.9381 +775 4 5.52691 32.2429 31.4849 -0.455553 -3.36681 1.56927 +776 4 5.05493 33.7218 31.1915 7.72328 25.1707 0.250012 +777 1 52.7526 32.6794 33.2917 -1.1678 -10.0217 7.16811 +778 2 52.3607 32.6823 34.7156 1.10255 -1.80451 -46.4405 +779 2 53.6298 32.9771 35.466 24.3124 -3.86391 3.03884 +780 3 54.7252 32.4235 35.2212 -23.0397 10.722 4.71956 +781 4 52.6718 31.7771 32.7765 -0.499018 10.5241 3.64804 +782 4 51.648 33.5318 34.8013 -6.43996 -0.39665 8.9378 +783 2 51.7643 31.3153 35.1205 -14.6608 -0.598675 31.299 +784 2 50.4472 31.4454 35.9643 8.77941 -15.5352 -26.1807 +785 2 50.5832 31.9625 37.3651 -2.67912 16.3525 37.5763 +786 3 49.9209 32.9494 37.7433 9.07957 -2.58057 -6.15032 +787 1 51.437 31.3297 38.2211 2.67596 1.57171 0.930055 +788 4 52.5216 30.7277 35.7054 -4.20254 0.0350677 -4.46682 +789 4 51.4878 30.6783 34.2719 3.29993 -4.42069 -15.0162 +790 4 49.9434 30.4567 35.9623 3.78404 -4.63917 10.5702 +791 4 49.6858 32.0412 35.427 2.21977 11.0074 -1.38139 +792 4 51.8063 30.3924 37.9705 2.16328 6.00798 1.3625 +793 4 51.6437 31.7399 39.1747 -6.68696 -10.5036 -22.3596 +794 1 53.5095 33.8962 36.42 -8.20166 25.4414 22.1973 +795 2 54.5747 34.3024 37.3295 -19.3274 -47.2338 19.7644 +796 2 54.3374 33.5175 38.6424 -52.3016 59.5202 -10.0971 +797 3 53.3688 33.7998 39.3891 18.863 -9.21915 -6.06634 +798 4 52.6243 34.4292 36.5865 8.7567 -9.68897 -5.69769 +799 4 0.524888 33.8606 36.995 20.2449 10.0463 -17.6441 +800 2 54.6326 35.7977 37.4305 -12.9517 47.1344 28.5316 +801 2 0.0326923 36.4499 36.0829 -2.43572 -2.53932 -10.8482 +802 2 0.0400304 37.9734 36.2703 -35.7369 26.7596 -9.32276 +803 2 1.42323 35.9178 35.6511 7.48175 21.564 37.2538 +804 4 0.37702 36.205 38.1946 -7.23177 -18.0499 -4.52301 +805 4 53.6103 36.1739 37.8346 22.3749 -7.86488 -15.795 +806 4 54.308 36.1878 35.2646 -5.73883 1.17112 4.65385 +807 4 54.1487 38.389 36.8719 12.989 -15.5349 -14.8375 +808 4 55.0091 38.5546 35.2982 1.66458 -12.2972 11.8538 +809 4 0.898146 38.314 36.8215 26.4509 7.27198 12.604 +810 4 1.38795 34.9003 35.2548 1.76467 -17.1685 3.06812 +811 4 2.15782 36.0461 36.5409 -11.2535 -11.763 -23.0993 +812 4 1.84494 36.4876 34.8385 7.70144 16.3511 -18.9114 +813 1 0.00368541 32.3928 38.6933 60.3495 -72.1401 -12.2197 +814 2 54.849 31.2911 39.6724 -12.054 11.0917 -33.5573 +815 2 0.456178 31.7903 40.9874 10.6429 2.84259 -7.8967 +816 3 1.61925 32.1816 41.0469 -1.25889 2.69502 -0.320895 +817 4 0.771148 32.2113 37.9508 -27.5595 2.34137 31.2634 +818 4 53.7516 31.0568 39.7052 4.35339 2.80588 13.4321 +819 2 0.572301 30.0297 39.0906 18.5839 -9.3637 1.30639 +820 2 0.330271 28.7129 39.848 -4.85336 -14.889 23.6916 +821 2 0.693398 28.6486 41.365 -25.7394 -2.5332 -16.7842 +822 3 54.7394 28.745 0.295995 1.88939 6.38348 7.55667 +823 3 1.88537 28.4667 41.718 12.1129 0.623711 3.73015 +824 4 1.68124 30.2872 39.0755 -12.926 -11.288 -1.20667 +825 4 0.269733 29.7427 38.025 4.32739 20.9521 12.5377 +826 4 0.909417 27.8521 39.409 -5.73579 9.2082 -7.491 +827 4 54.2152 28.4395 39.7334 16.9231 1.48772 2.1114 +828 1 54.6305 31.7883 0.132952 22.8608 6.07746 39.2243 +829 2 54.8576 32.3299 1.48573 -29.3221 31.1311 -21.4901 +830 2 1.17253 32.0229 2.2009 17.6366 -16.111 10.5973 +831 3 1.59057 32.8071 3.07156 -0.674056 0.0659302 -13.788 +832 4 53.659 31.6017 41.9208 -28.5726 -8.3455 -12.917 +833 4 54.8441 33.4787 1.30532 5.06012 -29.8204 14.0187 +834 2 53.6539 32.0394 2.47663 -0.820586 10.1398 -23.6755 +835 2 52.2239 32.3686 2.01123 21.8921 -9.62397 -13.268 +836 3 51.4302 33.0165 2.73635 3.85378 3.64717 10.9914 +837 3 51.8951 32.0293 0.84168 -3.94391 -2.23918 -4.0609 +838 4 53.7898 32.6162 3.39279 8.30271 4.42614 18.4259 +839 4 53.7249 30.9715 2.71423 -6.48233 -12.4206 11.3701 +840 1 1.80027 30.8157 2.00429 -3.41308 17.021 -11.1273 +841 2 3.01391 30.3872 2.67306 -17.4243 6.23421 51.1709 +842 2 4.3573 30.5827 2.00701 -14.1548 15.4243 -63.5733 +843 3 5.42088 30.6338 2.61698 6.51202 -0.211014 15.7475 +844 4 1.38736 30.0831 1.41283 -0.948729 3.54349 -2.60962 +845 4 3.08525 30.9412 3.69277 -1.85342 -9.762 -26.0847 +846 4 2.85031 29.3254 2.98975 11.9317 8.24793 -5.27874 +847 1 4.28888 30.743 0.620497 -12.3621 7.32386 22.4338 +848 2 5.32937 31.2764 41.6512 -13.8663 -29.5394 -9.66616 +849 2 5.57121 32.722 0.10225 -38.3787 16.5244 28.1783 +850 3 4.67744 33.4061 0.685107 26.0808 -18.0695 -15.0621 +851 4 3.36015 30.6914 0.159011 7.3551 0.286523 4.85155 +852 4 6.25759 30.6643 41.7722 1.97617 9.44883 5.82281 +853 2 4.84937 31.1813 40.1487 29.2597 0.863212 8.06821 +854 2 4.69879 29.8019 39.4857 10.4894 -21.0831 -13.1113 +855 2 5.6473 28.6668 39.9936 -13.3021 -14.9024 -16.8737 +856 1 5.27077 28.179 41.3306 -2.96519 4.49812 -11.7353 +857 2 6.06985 28.0105 0.470368 18.4061 -2.74343 27.4639 +858 1 7.404 28.2193 0.415809 -33.9112 -6.97322 0.0250223 +859 1 5.53751 27.6715 1.66745 7.41355 -4.5447 5.6764 +860 4 5.59287 31.7875 39.5584 -6.62026 -5.01092 -0.797873 +861 4 3.90042 31.6963 40.0361 -18.37 16.2558 -2.13315 +862 4 4.87993 29.9347 38.3602 -5.0628 -2.10161 17.6043 +863 4 3.66163 29.4121 39.5629 -5.01534 4.60088 1.06729 +864 4 6.67981 29.0441 39.9161 8.56645 -0.645935 3.00783 +865 4 5.57604 27.7587 39.2774 2.4211 23.1794 17.5601 +866 4 4.26853 28.0084 41.463 -5.17362 0.488763 -0.181308 +867 4 7.82192 28.2777 41.397 19.0269 3.46358 -1.03101 +868 4 7.9555 28.2212 1.28205 9.21585 -1.90571 -0.36079 +869 4 4.50489 27.4888 1.75639 19.7441 2.64647 4.92685 +870 4 6.15841 27.5559 2.53009 -21.7479 0.642981 -21.0512 +871 1 6.76075 33.214 41.6912 19.219 -12.8447 -16.8584 +872 2 7.12868 34.5749 41.8436 1.78261 35.3429 43.0116 +873 2 6.77609 35.3298 40.5962 -19.1975 -45.9981 -46.2181 +874 3 6.48326 34.7082 39.534 6.6414 26.9902 28.4778 +875 4 7.37626 32.7254 41.0127 -5.73863 2.32833 8.30529 +876 4 6.55071 35.0559 0.812315 8.37617 -12.7412 -20.2377 +877 2 8.6392 34.7953 0.238234 19.5739 7.90851 -48.6006 +878 3 9.35353 34.1854 41.0304 -12.8386 -4.95727 8.3137 +879 2 9.11551 34.1669 1.50873 -18.8724 -23.6236 42.9663 +880 4 8.9088 35.8955 0.234805 -6.25165 -9.40588 3.92441 +881 4 10.2786 34.3917 40.988 -0.40493 9.85267 11.4657 +882 4 10.1184 34.4515 1.79035 25.1513 6.04912 0.147779 +883 4 9.07131 33.0605 1.52977 2.37755 -2.72972 -9.56943 +884 4 8.50911 34.4369 2.41136 -0.948376 7.25744 -9.18832 +885 1 6.94474 36.6394 40.6556 -2.44135 26.6434 -23.8261 +886 2 6.9184 37.5467 39.5347 6.69905 -14.1713 -12.8446 +887 2 8.05389 37.1964 38.5245 -27.4859 18.9986 34.7956 +888 3 7.86013 37.2053 37.325 -9.29767 -2.30205 -27.2404 +889 4 7.0965 37.1097 41.5252 4.96112 6.67936 34.6112 +890 4 5.99819 37.3272 38.9586 -4.63141 4.06603 -3.57729 +891 2 6.96111 39.0217 40.0249 7.60343 4.99798 32.9439 +892 2 5.64771 39.5459 40.7503 13.3303 -11.7686 1.87571 +893 2 5.75985 41.0532 41.0609 20.2812 5.99168 -41.4278 +894 2 4.32816 39.2726 39.9704 18.565 3.35099 -29.4893 +895 4 7.21258 39.6788 39.2071 1.58444 12.8598 -26.2647 +896 4 7.87294 39.1662 40.7418 -24.807 -6.41168 -15.2883 +897 4 5.6203 39.0148 41.7319 -7.34537 -3.15131 1.25362 +898 4 4.91646 41.4032 41.6252 -26.0876 7.76092 9.54018 +899 4 5.84653 41.6805 40.0749 -1.44823 -14.0856 28.5036 +900 4 6.60816 41.2866 41.7276 9.52725 -0.69638 -3.08419 +901 4 4.29893 39.8385 38.99 0.215491 -3.12837 12.3269 +902 4 3.42741 39.5069 40.5265 -12.1672 8.54215 8.82184 +903 4 4.17367 38.2217 39.6869 7.24572 -5.84244 0.858739 +904 1 9.22626 36.8637 39.0427 21.4973 3.37181 48.1033 +905 2 10.3674 36.5714 38.2232 -9.10154 -9.23991 0.387697 +906 2 10.2983 35.2598 37.4643 -7.87493 -21.516 -1.82692 +907 3 11.0121 35.0941 36.4546 -10.096 5.18496 3.08952 +908 4 9.43559 37.0753 40.0799 -6.60045 -9.32212 -38.2223 +909 4 10.38 37.3229 37.4195 5.65865 10.6121 -8.5187 +910 2 11.637 36.6734 39.0312 17.5501 -7.37692 6.57672 +911 3 11.6795 35.7227 40.1079 -2.8679 20.1807 -0.19791 +912 4 11.748 37.6704 39.4409 -4.03165 17.0402 13.6797 +913 4 12.5247 36.6276 38.381 6.78129 -14.3562 -2.26856 +914 4 12.1944 34.9922 39.8075 10.5839 -13.8343 -8.97123 +915 1 9.37599 34.317 37.8723 17.0981 22.6825 36.4547 +916 2 9.03961 33.1663 37.0884 -21.5177 -32.5135 -8.8238 +917 2 8.42186 33.6216 35.772 12.1136 -61.8885 -37.6156 +918 3 8.46238 32.81 34.7849 1.32901 29.1307 35.9822 +919 4 8.95542 34.3811 38.853 10.4706 -4.46378 -29.0763 +920 4 9.93142 32.5518 36.7616 2.79547 16.9463 9.21372 +921 2 8.03197 32.1466 37.7484 3.42637 10.6841 -18.9321 +922 2 8.64707 31.2467 38.7916 -6.9544 1.67927 -4.64681 +923 3 8.29676 31.4213 39.9815 6.74685 -6.11142 9.13282 +924 3 9.44706 30.3423 38.4151 3.7337 3.36295 -6.87259 +925 4 7.50152 31.5448 36.9637 8.39997 -2.11551 6.41653 +926 4 7.19405 32.7023 38.1775 -8.25993 10.1263 10.5291 +927 1 7.75009 34.762 35.719 -22.4701 19.7147 -23.1057 +928 2 7.04455 35.3131 34.5484 -10.1936 -29.3849 23.8741 +929 2 7.86233 36.3488 33.8376 -13.0656 11.1044 -41.9487 +930 3 7.58485 36.6599 32.6528 -2.0293 -9.17756 21.4272 +931 4 7.63327 35.3235 36.5488 -2.91413 9.03335 17.0933 +932 4 6.86396 34.4501 33.8456 12.5342 10.3996 -5.08052 +933 2 5.61426 35.844 34.9306 19.6262 -1.52617 -28.8748 +934 2 4.83213 34.6653 35.4025 -10.2806 -24.7237 17.6593 +935 2 4.57558 34.457 36.7787 11.017 23.715 -9.65022 +936 2 4.42364 33.669 34.4835 -0.204454 17.9401 5.69744 +937 2 3.80293 33.3928 37.1817 -18.0339 -16.5573 23.9014 +938 2 3.6203 32.6104 34.8697 -1.59657 -1.57291 16.7967 +939 2 3.28719 32.4878 36.2185 14.3191 25.239 16.785 +940 3 2.42643 31.5967 36.7004 -21.786 -29.0921 6.36516 +941 4 5.08947 36.2348 33.9913 8.47084 3.13833 18.0937 +942 4 5.68856 36.6154 35.7126 -3.45102 11.3715 1.65586 +943 4 4.93536 35.177 37.5545 -2.85956 -5.82375 -8.46254 +944 4 4.68581 33.7849 33.4351 -1.13786 -0.0334624 -10.731 +945 4 3.5508 33.3312 38.3093 3.7661 -3.16504 -32.8067 +946 4 3.21561 31.8879 34.1609 -1.14089 -4.88721 -7.16666 +947 4 2.07822 31.0058 36.0335 4.80509 5.07869 -1.12919 +948 1 8.89276 36.9109 34.4697 3.08208 2.61779 2.42454 +949 2 9.71554 37.9518 33.9536 6.78836 41.9101 -7.41895 +950 2 8.87118 39.1918 33.5791 -2.83098 -3.29658 16.5328 +951 3 9.07345 39.7706 32.5156 6.00915 0.294316 2.75033 +952 4 9.0886 36.6939 35.4314 3.3626 -5.13227 22.9354 +953 4 10.4005 38.393 34.7625 -11.752 -18.5108 -5.62727 +954 2 10.5665 37.5273 32.7526 17.9231 -22.0125 -23.4044 +955 2 11.7038 38.502 32.4536 -20.96 9.74481 -37.2535 +956 3 11.6878 39.1949 31.3977 0.540028 -8.54016 25.273 +957 1 12.687 38.5377 33.3475 38.0496 20.2334 23.5086 +958 4 9.97947 37.4403 31.7814 1.01798 2.165 18.3599 +959 4 11.0193 36.505 32.8955 -2.74071 8.1052 0.988861 +960 4 12.6531 37.864 34.1655 7.32082 17.5294 -13.3715 +961 4 13.4532 39.3055 33.2787 -30.6572 -33.7139 4.421 +962 1 7.93658 39.5767 34.4996 32.6534 -23.6413 -9.43678 +963 2 7.20273 40.8089 34.5743 -2.74612 21.1773 -15.346 +964 2 8.21766 41.8982 34.9197 -3.45605 -13.7782 10.2915 +965 3 8.98784 41.7778 35.8832 -3.40272 -3.46005 -6.10842 +966 4 7.93188 38.9898 35.3424 -7.46187 6.56739 7.86278 +967 4 6.79415 41.087 33.5295 1.97546 -9.26453 20.6229 +968 2 6.06472 40.6271 35.6481 -5.08297 -2.08213 -22.9213 +969 2 4.90833 39.9858 34.8157 -12.6977 -10.7104 -3.72739 +970 2 5.64222 41.9226 36.403 -2.05312 -2.0705 -19.9517 +971 2 3.84054 39.2603 35.6406 -0.0147652 -3.33058 30.6695 +972 4 6.3943 39.8459 36.3734 2.85979 7.06395 10.3389 +973 4 5.33061 39.1839 34.1245 -4.62997 12.2623 4.99778 +974 4 4.37584 40.73 34.1591 8.26763 -2.20969 2.2716 +975 4 4.92993 41.6478 37.2106 -0.0042749 6.0371 4.19307 +976 4 5.15795 0.778755 35.7389 -1.27911 -10.984 2.34352 +977 4 6.51935 0.549814 36.8166 0.412823 -4.00159 10.9885 +978 4 3.21428 39.9846 36.2492 8.55414 -9.22464 -7.99451 +979 4 4.28582 38.4972 36.3757 -6.36125 15.4526 -14.7269 +980 4 3.14756 38.696 34.9847 -1.95473 -0.292674 -1.44435 +981 1 8.25206 1.08297 34.1638 31.3741 38.5442 9.59718 +982 2 9.18814 2.19093 34.4552 -11.7272 -14.356 -0.722089 +983 2 8.45749 3.48131 34.8023 4.76941 7.21795 3.77261 +984 3 7.24176 3.59586 34.6101 4.23254 1.41941 3.46139 +985 4 7.75397 1.25241 33.3001 -16.6469 -12.6897 -14.3012 +986 4 9.75614 1.90919 35.3591 7.11639 4.99627 7.91164 +987 2 10.1452 2.40125 33.2642 -9.36205 3.53781 1.41258 +988 2 11.145 1.26701 33.0621 15.3724 -18.5317 -10.2549 +989 2 12.3408 1.2215 34.0193 -34.6799 -20.8737 -4.25674 +990 3 13.4283 1.6066 33.6334 28.2263 9.73281 -4.88467 +991 1 12.1185 0.540183 35.1633 28.8031 2.35628 29.4382 +992 4 10.7148 3.34616 33.3936 1.59432 0.534457 -2.79864 +993 4 9.49714 2.55965 32.3759 6.01649 -0.268224 -5.10448 +994 4 11.6127 1.34439 32.0577 -0.769775 9.57011 -1.56393 +995 4 10.6933 0.251936 32.9886 -5.52334 3.35231 7.85959 +996 4 11.2139 0.219277 35.5156 -12.526 -0.0546681 -6.86711 +997 4 12.9016 0.455342 35.8573 -9.00019 3.15098 -17.6728 +998 1 9.24699 4.48326 35.2867 7.50516 -22.9453 -9.87373 +999 2 8.79457 5.81029 35.6553 19.4094 -0.44208 23.4194 +1000 2 7.94193 6.35186 34.5098 -28.0836 13.7832 22.6841 +1001 3 8.26577 6.15625 33.3485 3.32417 -1.59684 -17.5239 +1002 4 10.2626 4.25405 35.3107 -8.01304 16.2193 5.9612 +1003 4 8.1894 5.68577 36.5846 -11.6257 -0.00282829 -7.04897 +1004 2 9.97767 6.74716 36.1433 -23.7266 14.1696 -20.2452 +1005 2 11.1395 6.93836 35.1562 2.17384 -4.68321 -25.171 +1006 2 12.442 7.40754 35.8023 6.89417 23.6707 25.6501 +1007 2 12.3585 8.87197 36.3546 -17.7601 7.18701 6.16378 +1008 1 13.652 9.40345 36.7619 -5.05233 -10.0697 25.3038 +1009 4 10.4674 6.41708 37.0624 -6.17454 -12.8958 16.6295 +1010 4 9.46609 7.72624 36.4439 19.6997 -12.4825 -9.52898 +1011 4 10.8586 7.67723 34.3661 -2.31205 -2.27426 2.47252 +1012 4 11.3956 5.98923 34.5935 -8.15618 9.36142 7.97067 +1013 4 13.285 7.3766 35.0989 4.02069 -2.74272 -14.2107 +1014 4 12.7725 6.74228 36.6382 -4.94702 -0.810609 -4.3443 +1015 4 11.6162 8.97546 37.2517 21.5709 -5.37851 -23.6156 +1016 4 11.9848 9.59279 35.5592 1.32622 -13.234 7.43529 +1017 4 13.5097 10.3531 37.0548 1.1249 12.5728 4.15723 +1018 4 14.3076 9.4933 35.9914 2.38442 -5.54985 1.16984 +1019 4 14.0989 8.9471 37.5942 -8.28554 10.0467 -28.7492 +1020 1 6.74258 6.95961 34.8453 13.8439 -7.08515 -31.5666 +1021 2 5.70412 7.47847 33.9372 22.4359 17.1833 28.8896 +1022 2 4.73468 6.47268 33.3926 -37.2702 -51.3286 -21.7325 +1023 3 3.66084 6.82477 32.8505 20.0183 9.28716 8.38675 +1024 4 6.50761 7.12516 35.8163 -0.959582 1.3178 20.8718 +1025 4 5.07512 8.17388 34.5809 1.06569 -12.1955 -8.24357 +1026 2 6.27511 8.35576 32.8097 23.4106 2.51452 -13.5767 +1027 2 6.97942 9.67377 33.2004 -16.9954 14.0421 10.4255 +1028 2 6.10535 10.8129 33.826 12.866 -26.3315 -27.4761 +1029 3 5.32563 11.4369 33.048 -2.57309 4.89094 -0.177716 +1030 3 6.28787 11.1355 35.0235 5.56298 3.82152 16.5631 +1031 4 5.49496 8.55729 32.0786 -16.2509 9.70978 -5.42728 +1032 4 7.00993 7.79082 32.1666 -6.62982 -1.98309 13.432 +1033 4 7.44051 10.1227 32.2823 5.63402 -3.39012 2.91122 +1034 4 7.79617 9.4262 33.9151 4.88029 0.56984 -5.69246 +1035 1 4.9985 5.11713 33.407 24.659 21.8647 21.6253 +1036 2 4.05493 4.11234 32.9569 -19.5991 11.2557 -30.6753 +1037 2 2.66349 4.36425 33.564 5.77052 11.5327 33.941 +1038 3 2.61183 4.63212 34.7889 -10.6254 -2.1096 -24.9185 +1039 4 5.90798 4.72579 33.7623 -18.8375 16.0079 -6.75199 +1040 4 3.94963 4.2178 31.8123 4.18537 -9.18741 21.4869 +1041 2 4.52113 2.73738 33.4375 8.25229 -17.2331 29.0433 +1042 3 5.75234 2.38881 32.7881 -21.5054 -2.62865 -12.7372 +1043 4 3.76903 1.95227 33.2696 -3.85539 -5.9091 -13.5606 +1044 4 4.62925 2.69715 34.589 6.20333 6.93314 -25.3828 +1045 4 6.43526 2.61043 33.3995 7.46021 4.72267 11.925 +1046 1 1.55191 4.21884 32.8032 -14.0425 -5.15851 -21.6842 +1047 2 0.161375 4.25438 33.2368 -9.40026 13.4655 23.096 +1048 2 54.692 2.80115 33.3646 18.1492 -1.83923 -37.1888 +1049 3 54.7885 2.04564 32.3679 -9.76904 2.34815 11.9713 +1050 4 1.58614 3.87283 31.8209 11.2241 6.42129 12.946 +1051 4 0.0932821 4.78062 34.2407 6.57702 -9.00044 -6.29593 +1052 2 54.1421 5.03026 32.3092 -30.8516 -27.3257 32.8914 +1053 3 54.4529 6.38645 32.3432 43.6526 11.7784 12.1317 +1054 2 52.6693 5.00292 32.8811 18.0931 2.75777 -15.9968 +1055 4 54.1554 4.62002 31.3044 4.18983 -2.87474 -22.2473 +1056 4 53.8639 6.90955 31.8518 -25.2917 13.9269 -18.693 +1057 4 52.66 5.46781 33.8932 -7.48107 5.39969 -2.18241 +1058 4 52.249 3.98991 33.0062 0.231344 -5.48034 -3.27193 +1059 4 51.9963 5.5356 32.1423 1.66512 -1.40627 14.088 +1060 1 54.1705 2.41097 34.5199 1.80418 26.5965 31.5441 +1061 2 53.4771 1.1604 34.7223 -23.5881 -17.4143 30.2256 +1062 2 51.9672 1.43692 34.4286 45.4706 11.6959 19.6168 +1063 3 51.5098 2.51334 34.8139 -14.0548 -1.70012 -4.22959 +1064 4 54.1449 3.13072 35.3168 -2.84084 -28.6208 -21.3152 +1065 4 53.8073 0.317305 34.0552 7.54144 10.0832 -0.542806 +1066 2 53.6466 0.727247 36.2732 15.0023 -0.977243 -19.0787 +1067 2 0.11045 0.778115 36.8855 -3.47233 23.3808 -12.4462 +1068 2 0.174657 0.0352411 38.2454 9.71436 -6.65086 -1.81426 +1069 2 1.19132 0.222888 35.8995 6.11034 15.7938 3.95568 +1070 4 53.2393 41.6189 36.352 -4.11551 -11.0062 3.39296 +1071 4 53.0266 1.35722 36.9407 -10.5209 2.31976 -3.99924 +1072 4 0.276909 1.89779 37.0745 11.3679 -17.77 -1.06189 +1073 4 54.361 0.442618 38.9125 4.10216 -8.97134 2.26246 +1074 4 1.16474 0.174268 38.7716 -10.2453 4.64912 -5.91146 +1075 4 0.0894693 40.827 38.1128 -8.07449 10.5575 2.47406 +1076 4 2.18017 0.0911741 36.3628 0.498668 -8.86502 15.8712 +1077 4 1.51082 0.946112 35.1046 -21.6742 -5.82018 -4.77892 +1078 4 0.87048 41.1455 35.5035 3.84873 -0.316194 -7.96637 +1079 1 51.2572 0.510776 33.7869 -35.0849 -22.21 -18.422 +1080 2 49.7991 0.651464 33.5457 -7.89552 -1.42073 2.85742 +1081 2 49.1064 41.7127 34.6422 20.8091 24.7993 -30.4476 +1082 3 49.3211 40.5176 34.6928 0.936017 -16.9834 6.81615 +1083 4 51.5685 41.4333 33.6514 6.90564 11.6478 3.53197 +1084 4 49.4699 1.73569 33.6536 7.71362 -9.58165 1.5915 +1085 2 49.2914 0.124722 32.1435 -1.6477 0.542595 21.3952 +1086 2 49.5957 1.07684 31.016 -40.6033 -15.585 26.437 +1087 1 48.7294 1.99918 30.4836 -27.6566 13.4748 -4.54446 +1088 2 50.7297 1.21695 30.3262 36.7247 10.1326 -33.1818 +1089 2 49.2902 2.59089 29.4013 15.6758 12.8861 -16.3634 +1090 1 50.5605 2.13547 29.3267 -27.6128 -3.77706 23.4645 +1091 4 48.1729 41.8384 32.2733 14.3125 6.04861 -12.1255 +1092 4 49.7214 41.0254 31.9181 -0.443629 4.48635 2.11286 +1093 4 47.7408 2.2006 30.8029 20.1006 -6.4749 -2.25561 +1094 4 51.6449 0.698065 30.4056 15.084 -12.5894 5.57169 +1095 4 48.9104 3.2954 28.6425 -5.47018 -10.6135 19.6435 +1096 4 51.2563 2.40703 28.6421 12.9903 7.46191 -13.5301 +1097 1 48.3611 0.457254 35.523 -13.4783 35.8963 4.98689 +1098 2 47.6684 41.7265 36.6028 -12.609 2.82517 16.7739 +1099 2 46.2613 41.336 36.1362 14.2498 9.86212 -6.63619 +1100 3 45.3696 0.249228 35.9008 11.2544 -8.11188 8.40093 +1101 4 48.1527 1.47601 35.3837 2.04907 -15.0615 5.33592 +1102 4 48.2568 40.8085 36.8471 -2.89667 -2.02658 5.80089 +1103 2 47.5596 0.692305 37.8969 5.07609 12.8861 -15.4572 +1104 2 46.7247 0.067171 39.0652 -23.3887 -7.36646 -24.3057 +1105 2 47.033 40.4837 39.4166 -14.2982 16.8046 -18.6717 +1106 2 46.9311 0.907751 40.3269 20.2628 20.9695 31.7148 +1107 4 47.0803 1.72619 37.5586 18.4264 -28.4903 17.3716 +1108 4 48.6288 0.838001 38.2574 -15.841 5.68773 -4.62102 +1109 4 45.6307 0.107149 38.6982 15.4635 0.946246 17.2142 +1110 4 48.0197 40.3992 39.8616 17.8935 -6.94949 10.1905 +1111 4 47.0012 39.8155 38.524 1.84183 3.03864 3.36861 +1112 4 46.2605 40.0937 40.1174 3.5183 -0.242765 2.2201 +1113 4 48.0596 1.05972 40.5786 -27.9597 -7.64804 -5.61245 +1114 4 46.4366 0.492644 41.2461 4.13191 -4.52617 -8.48469 +1115 4 46.5029 1.93558 40.2678 1.33797 -2.98423 -8.86627 +1116 1 46.1363 40.0225 35.9719 -11.8784 -48.163 0.632693 +1117 2 44.9067 39.2611 35.7716 22.3959 0.0668878 -14.2888 +1118 2 44.4049 38.8629 37.1725 -35.2322 11.6067 -22.5418 +1119 3 45.1472 38.486 38.0617 14.0918 -2.68919 9.70234 +1120 4 46.908 39.3425 36.1226 1.34088 13.782 2.29065 +1121 4 44.2497 39.8817 35.1331 -17.245 4.97255 12.4072 +1122 2 45.2366 37.985 34.8925 -4.99104 -6.23114 -9.17669 +1123 2 44.0069 37.0072 34.8313 5.26574 11.342 7.98842 +1124 2 45.6195 38.3915 33.4226 -3.76358 -20.0352 6.70883 +1125 4 46.1177 37.4383 35.3134 -3.76426 -1.15462 7.05426 +1126 4 43.5316 36.9313 35.8696 0.358942 -6.34703 -24.4349 +1127 4 44.3242 35.9956 34.5249 4.20531 -7.16171 2.34616 +1128 4 43.2753 37.3126 34.0403 -3.87397 3.42825 10.5933 +1129 4 46.6384 38.8467 33.4221 -3.79452 2.69366 -2.61982 +1130 4 44.9004 39.1304 33.0043 0.823619 -0.608417 -3.73086 +1131 4 45.6564 37.4663 32.7381 0.0287792 19.4258 11.3413 +1132 1 43.0561 38.9062 37.36 16.7964 -0.846157 38.4014 +1133 2 42.4272 38.5172 38.6279 -14.5421 -18.7427 13.0828 +1134 2 41.8753 37.0763 38.5124 -8.78692 12.5845 -64.2445 +1135 3 41.466 36.6885 37.3717 6.29707 6.96761 32.6735 +1136 4 42.3774 39.0214 36.6331 -15.2734 7.16413 -28.2079 +1137 4 43.1919 38.4467 39.4108 16.1917 0.0561369 8.47296 +1138 2 41.3404 39.5151 39.1514 -18.2527 2.1619 5.40726 +1139 2 42.0205 40.8503 39.6333 -29.5812 13.2835 -20.5362 +1140 2 41.0689 0.171231 39.4112 30.2059 17.4331 -9.29433 +1141 2 42.4678 40.816 41.1078 15.9246 -23.8206 -10.1516 +1142 4 40.688 39.0893 39.9799 16.7303 0.907162 -6.07322 +1143 4 40.5588 39.6983 38.3606 15.4269 0.857054 0.728379 +1144 4 42.8535 41.0549 38.9416 17.5291 -0.3509 1.61726 +1145 4 41.6271 1.1561 39.6676 -14.9721 -22.7636 -0.520954 +1146 4 40.1564 0.111331 40.0029 -13.6089 -0.269988 10.9836 +1147 4 40.76 0.320829 38.3386 1.94315 -8.64923 8.74761 +1148 4 41.6626 40.4848 41.7802 -9.99726 5.60483 6.07701 +1149 4 42.8258 41.8281 41.4135 4.90552 -5.57863 6.49728 +1150 4 43.2679 40.0127 41.241 -4.54696 19.1865 -0.92221 +1151 1 41.8233 36.2733 39.5754 -3.61756 -11.0936 16.9633 +1152 2 41.1922 34.957 39.6399 -10.4088 -17.6704 -50.7121 +1153 2 39.8412 35.0841 40.3193 -0.437683 4.39576 10.763 +1154 3 39.8144 35.4746 41.4864 -9.76 5.96233 -2.547 +1155 4 42.2323 36.5766 40.4577 6.86651 4.46574 10.4638 +1156 4 40.9934 34.6386 38.4963 8.65196 -1.15376 42.0164 +1157 2 42.0562 33.8903 40.4247 20.8855 33.0106 -9.02378 +1158 2 41.3005 32.6543 41 38.0556 15.2529 -12.1112 +1159 2 42.2217 31.3951 41.1067 -29.8496 -30.3433 -13.4218 +1160 1 43.3285 31.549 0.111927 13.7517 39.8644 23.5527 +1161 2 44.3839 30.7268 0.286736 21.6234 19.2182 17.9174 +1162 1 44.681 29.6113 41.5428 -25.8767 -16.3024 -25.7307 +1163 1 45.3493 31.1499 1.13058 -39.3833 23.49 -6.35183 +1164 4 42.617 34.5166 41.192 -12.3652 -23.3828 3.531 +1165 4 42.8948 33.5841 39.7601 -4.64767 -6.80459 -5.17496 +1166 4 40.4819 32.4474 40.3056 -13.8786 -11.9041 -4.8646 +1167 4 40.8645 32.9834 0.0421702 -8.7777 -8.2778 13.4879 +1168 4 42.5872 31.067 40.0872 -0.36901 12.0823 9.30135 +1169 4 41.553 30.5032 41.4129 16.6518 20.7036 2.18161 +1170 4 43.3615 32.497 0.627799 -1.11121 -36.4642 -14.6418 +1171 4 44.0326 29.3067 40.7749 11.9664 -0.606259 12.9296 +1172 4 45.4908 28.9966 41.7635 -4.5997 7.04477 0.652143 +1173 4 45.2947 32.0222 1.6989 -3.32167 -9.1207 -8.17541 +1174 4 46.1369 30.5772 1.3332 29.28 -20.6173 7.21336 +1175 1 38.7318 34.7203 39.6307 -5.56998 -4.40152 -32.2775 +1176 2 37.3555 34.7738 40.1542 17.1032 1.0045 -6.37855 +1177 2 37.2353 33.667 41.1913 -33.3614 37.0741 40.0449 +1178 3 37.7005 32.5636 40.9891 18.731 -32.0974 -3.65368 +1179 4 38.8335 34.3404 38.6486 -6.51334 12.5121 23.5529 +1180 4 37.2672 35.7762 40.6273 -9.086 1.46109 5.84779 +1181 2 36.2453 34.5638 39.0845 -6.93832 -9.37108 -7.97374 +1182 2 36.1701 35.614 37.9414 8.91404 15.2365 -6.3275 +1183 2 35.3527 35.0344 36.7472 39.8054 8.21108 -27.9 +1184 2 35.4841 36.9314 38.4139 -18.287 13.7727 -16.8718 +1185 4 35.232 34.5024 39.5744 7.45292 -0.257102 0.0904576 +1186 4 36.3852 33.5433 38.6164 0.781265 7.17557 6.89015 +1187 4 37.2115 35.9047 37.5843 -11.2451 -10.8797 5.10717 +1188 4 35.5662 35.6385 35.778 -16.1675 -5.48794 25.897 +1189 4 34.291 34.967 37.0013 -15.7304 -0.876038 -4.35202 +1190 4 35.7074 34.0135 36.4456 -4.10332 3.28733 9.08934 +1191 4 35.4655 37.7439 37.5577 -4.97646 -27.0735 23.6494 +1192 4 36.0148 37.4196 39.237 12.1669 1.46201 8.99598 +1193 4 34.4369 36.7462 38.8365 16.8945 3.16641 -16.172 +1194 1 36.5334 33.9935 0.435925 10.1465 7.38421 -15.9691 +1195 2 36.4058 33.2568 1.6875 16.4821 -29.3274 -13.0782 +1196 2 35.1468 33.6833 2.42741 -3.52585 26.4938 2.22063 +1197 3 34.7699 34.8785 2.50349 9.50092 -20.8144 -9.83338 +1198 4 35.9506 34.8486 0.439937 7.33038 -6.12466 -5.51472 +1199 4 36.3499 32.1247 1.42412 1.62075 26.2077 7.36918 +1200 2 37.675 33.5505 2.58336 -0.681506 -6.35683 7.58589 +1201 2 37.7854 32.6927 3.8625 18.6921 -17.668 32.0141 +1202 2 39.0575 32.9332 4.76873 14.2724 -20.5826 -30.9069 +1203 1 39.1289 34.2491 5.33109 11.0713 19.2422 13.5273 +1204 2 40.0441 34.6938 6.2528 -38.5124 5.77538 -21.346 +1205 1 41.0523 34.0015 6.75388 -9.3068 -30.315 -40.8639 +1206 1 39.7573 35.8959 6.75045 4.65044 -37.6482 -19.533 +1207 4 37.7117 34.6025 2.94212 -4.78803 6.98284 -11.1897 +1208 4 38.6033 33.3783 1.98429 -1.50456 2.19712 -0.683264 +1209 4 37.8193 31.5994 3.65006 -4.42508 0.799529 -11.9295 +1210 4 36.9318 32.7949 4.56147 -11.5542 5.52665 -5.70323 +1211 4 39.9727 32.6563 4.13477 -10.3426 12.9457 13.0222 +1212 4 39.0991 32.232 5.62646 -6.41615 -9.9444 -1.6393 +1213 4 38.3112 34.8566 5.12728 9.08197 -0.1797 3.06874 +1214 4 41.338 33.0965 6.26824 1.29043 26.2885 21.8424 +1215 4 41.5567 34.3995 7.53172 18.6054 -2.34736 15.9895 +1216 4 38.9283 36.4191 6.51463 -17.6749 8.57537 -7.4588 +1217 4 40.3535 36.2619 7.44459 24.2502 25.7988 36.1589 +1218 1 34.4423 32.7029 2.99518 -5.91218 -18.2551 8.17758 +1219 2 33.2643 32.9205 3.78866 2.14491 3.18155 15.0212 +1220 2 32.3114 31.74 3.93685 27.6029 1.93064 -50.2862 +1221 3 31.6521 31.6162 4.95167 -20.1995 -6.42992 23.3772 +1222 4 34.7506 31.7123 2.9878 2.11082 4.57648 -1.08475 +1223 4 33.5885 33.2179 4.82725 -4.56531 -3.45872 -11.3922 +1224 4 32.6993 33.791 3.40271 -6.19117 1.50996 -1.33542 +1225 1 32.2733 30.8792 2.86255 -3.44833 -0.807911 26.2314 +1226 2 31.5067 29.6456 2.87911 -22.6819 -12.0155 6.38652 +1227 2 32.0275 28.5204 1.99364 -17.4826 -15.7648 -26.1521 +1228 3 31.24 27.9052 1.1757 18.2868 13.9435 17.0259 +1229 4 32.9257 31.0189 2.07167 -6.99587 -10.4877 -2.31778 +1230 4 31.4409 29.1882 3.92659 1.7726 14.0477 -11.6562 +1231 4 30.4172 29.8482 2.57519 20.7941 0.876843 7.98191 +1232 3 33.2432 28.1769 2.02662 6.75216 10.2675 5.6015 +1233 6 29.6689 33.0345 2.6027 6.39732 3.7635 -6.59735 +1234 4 28.7656 33.0857 2.95028 -0.371973 -14.4593 -6.85361 +1235 4 29.8153 32.1814 2.14015 -8.59972 11.6466 4.8732 +1236 6 1.91326 24.7635 28.0772 5.65317 -6.35183 16.4854 +1237 4 1.01929 24.4316 28.2568 3.94453 1.46201 -0.938269 +1238 4 2.46517 24.4471 28.8255 -6.59296 2.11781 -11.8027 +1239 6 8.98979 35.4216 7.06427 2.13264 0.908259 -3.07356 +1240 4 8.22375 36.0041 6.95701 -0.608539 -3.26387 0.365744 +1241 4 9.74616 35.991 6.87666 4.70766 2.91314 -0.442423 +1242 6 37.9357 35.2342 23.5273 -23.102 9.18642 19.8247 +1243 4 37.5041 35.2968 22.6705 0.513901 -3.82007 -8.89977 +1244 4 38.8432 35.0218 23.4038 20.8563 -8.17935 -11.4372 +1245 6 11.3793 34.6137 20.3253 14.1507 4.32837 -4.20952 +1246 4 10.4755 34.624 20.6003 -22.0831 6.77293 1.73618 +1247 4 11.7264 33.9016 20.8561 13.9299 -11.0914 4.04985 +1248 6 3.06607 13.1144 13.5167 22.577 18.8722 18.6067 +1249 4 2.20388 12.8262 13.8046 -7.02328 -4.57126 0.810516 +1250 4 3.32154 13.8092 14.1761 -2.44089 -14.0351 -15.8923 +1251 6 9.17443 22.3777 24.8954 -7.42914 3.56866 8.74917 +1252 4 9.07626 22.0242 24.0039 2.26474 -2.4656 -3.7019 +1253 4 8.26912 22.4958 25.2295 3.15193 -1.43545 -3.27774 +1254 6 31.1464 36.1236 7.45234 10.6607 -18.1227 -24.2194 +1255 4 30.9334 35.2222 7.12747 -5.34615 12.6105 12.538 +1256 4 31.8314 36.3443 6.79825 -5.43643 8.62165 8.26122 +1257 6 20.3227 0.172698 30.1419 10.3105 -3.05703 7.76208 +1258 4 20.0388 1.0684 29.8874 5.3247 -3.32009 0.781739 +1259 4 21.2583 0.228399 30.4322 -11.2768 6.47679 -5.28094 +1260 6 32.6859 3.01778 5.15829 -10.6028 -19.0303 43.6625 +1261 4 32.0356 2.3058 5.02019 7.54008 9.83835 -8.28794 +1262 4 32.7128 3.00557 6.15578 5.12118 6.62375 -23.7252 +1263 6 26.2374 8.27856 11.5971 17.869 0.788073 20.0593 +1264 4 26.2346 7.39991 12.0216 -0.142457 7.42091 -4.28305 +1265 4 26.8978 8.79254 12.1302 -17.5189 -15.6641 -18.5798 +1266 6 1.09614 20.2561 0.875192 -22.9747 0.467748 19.1373 +1267 4 0.851949 19.3199 1.10255 19.4844 20.3298 -11.3195 +1268 4 1.85437 20.3448 0.297385 12.1513 -16.76 -9.59627 +1269 6 29.1514 22.9126 1.42851 -3.57267 15.5796 12.2113 +1270 4 28.6966 23.7416 1.67141 5.52941 -12.1705 -9.88265 +1271 4 29.6634 22.7027 2.22543 0.165437 -2.26551 -2.85175 +1272 6 34.1399 34.826 6.47271 -4.00425 12.5535 -7.93856 +1273 4 34.8635 34.3401 6.10458 13.259 -3.54932 -9.87122 +1274 4 33.9387 34.3337 7.25184 -8.28913 -2.66912 16.7304 +1275 6 25.1643 37.1931 26.5228 17.2229 -22.0393 -23.1844 +1276 4 24.6935 37.7676 27.1042 -4.31343 22.2846 18.4719 +1277 4 26.0117 37.6203 26.271 -7.79876 5.52479 6.28113 +1278 6 14.5333 22.2337 15.6719 -21.8235 -40.5779 4.16881 +1279 4 14.0435 21.3187 15.7268 23.5152 50.9834 -4.51283 +1280 4 14.2451 22.7392 14.8947 -1.224 -10.8945 3.63574 +1281 6 2.86145 5.86342 4.09514 -12.0928 12.5672 -7.55007 +1282 4 3.31871 5.53612 4.87755 -0.114002 3.3263 11.1441 +1283 4 2.36891 6.69134 4.30817 11.5092 -15.7361 4.93451 +1284 6 27.6072 26.7133 22.7037 11.3111 -21.4893 35.9413 +1285 4 26.8221 26.1673 22.7712 -7.10606 -4.70529 -2.97044 +1286 4 27.5145 27.2572 21.9514 -10.0855 20.8317 -32.7258 +1287 6 17.7799 0.609907 22.4001 -5.17757 10.6635 4.04288 +1288 4 17.0763 0.657064 23.0885 11.5181 4.04392 -9.91171 +1289 4 18.0806 1.5364 22.261 -7.85301 -10.5281 2.59652 +1290 6 8.08893 9.42761 10.5595 3.55537 5.25916 40.324 +1291 4 7.89361 10.322 10.3179 -9.19974 15.7377 -19.3495 +1292 4 8.16563 9.56196 11.5399 2.2102 -21.2534 -20.7584 +1293 6 15.3508 8.71886 30.755 5.09068 -14.416 21.7005 +1294 4 15.721 8.98141 29.9127 -5.17651 10.4904 -11.2194 +1295 4 14.5411 9.19598 30.997 6.64715 3.62724 -9.30987 +1296 6 11.0273 17.2714 37.5546 -8.62993 4.63856 -3.16721 +1297 4 10.646 18.1523 37.5049 13.3861 11.3255 -4.88271 +1298 4 10.2437 16.8378 37.8681 -2.55755 -24.0409 7.53141 +1299 6 42.0954 25.1585 20.3881 14.6842 1.84925 -24.6227 +1300 4 41.6997 25.8318 19.7943 -2.16553 -3.48259 16.6789 +1301 4 41.6994 25.1952 21.2528 -9.02961 7.39914 10.888 +1302 6 25.8656 4.70522 33.8434 4.94337 -17.9304 30.0995 +1303 4 25.7948 4.41246 32.9437 -1.56424 4.53154 -20.9619 +1304 4 25.7821 5.65919 33.9019 -2.93726 10.638 -9.31877 +1305 6 28.7565 10.7943 24.343 5.31048 -5.66707 -17.5237 +1306 4 29.0395 10.691 25.2776 6.61806 -8.7001 -20.887 +1307 4 29.3174 10.2678 23.7025 -8.86987 6.64124 26.5787 +1308 6 5.00601 41.813 11.1 6.11697 -35.3303 28.6791 +1309 4 5.97939 41.6679 11.0741 -12.7816 8.03831 -2.02432 +1310 4 4.68345 41.1078 11.7429 5.5471 25.1349 -25.8779 +1311 6 51.7607 12.785 30.1531 41.9873 7.8243 6.58168 +1312 4 51.5044 13.1989 29.3224 -3.76645 3.26875 -7.63234 +1313 4 52.7548 12.9452 30.2104 -29.821 -7.22149 1.35463 +1314 6 7.60527 6.19156 6.53697 16.5093 0.883216 -0.386471 +1315 4 6.7728 6.50088 6.91441 -4.77803 -9.70632 -1.71599 +1316 4 7.48617 5.31021 6.15237 -11.2115 3.19853 1.4886 +1317 6 14.6639 26.9856 30.1439 5.75321 15.8705 11.2484 +1318 4 14.5566 27.0259 31.1175 -3.12227 -7.05885 -13.9758 +1319 4 15.1715 27.7926 29.9326 -6.11328 -7.83436 0.701957 +1320 6 15.3386 3.73742 21.1629 -49.5233 -4.42818 1.41573 +1321 4 14.7513 4.15862 21.8308 22.5595 -2.74077 -5.2282 +1322 4 14.679 3.20837 20.6508 28.7222 9.19721 3.95726 +1323 6 18.6168 30.4391 6.46727 22.6827 -23.6706 30.2016 +1324 4 19.0357 29.7477 7.08277 -19.2097 26.0479 -21.7287 +1325 4 19.3376 31.0911 6.37388 -10.7119 -2.89972 -1.77141 +1326 6 40.7683 1.30949 12.8061 -7.58564 4.37034 -9.51004 +1327 4 39.8743 1.70123 12.8539 8.02325 -2.8267 0.614513 +1328 4 41.1302 1.62292 11.9594 1.79027 -4.37486 1.66609 +1329 6 17.747 20.7401 41.5828 -14.5708 23.9699 -22.25 +1330 4 16.8287 21.1121 41.5273 18.852 -12.8662 8.2158 +1331 4 18.269 21.3043 40.983 -0.296974 -7.34806 11.4382 +1332 6 20.4522 2.1467 12.3338 -13.8993 16.4183 -18.7538 +1333 4 19.8428 1.38545 12.4588 7.32118 14.6694 -7.56396 +1334 4 20.1591 2.61844 11.4836 4.96023 -26.6086 29.2353 +1335 6 9.8437 37.1731 18.0697 32.5344 -3.69518 -7.02483 +1336 4 9.9915 37.607 18.9153 -11.6933 2.16478 7.61773 +1337 4 10.7629 37.1686 17.7045 -22.2666 -4.61022 -1.39483 +1338 6 22.8273 7.39987 18.8956 -5.5011 7.28813 -36.492 +1339 4 23.2632 7.84344 18.1165 -7.98371 -8.25387 20.5209 +1340 4 21.8866 7.2843 18.6392 14.3432 0.686453 4.84686 +1341 6 12.8601 6.85899 39.0577 6.92589 -13.3495 -12.6124 +1342 4 12.2887 7.60854 39.1608 -14.8411 14.7282 0.271429 +1343 4 13.3423 6.79713 39.8797 5.00888 -0.905409 12.2129 +1344 6 10.1643 2.40912 23.2548 -13.4149 21.1074 -1.06732 +1345 4 10.2774 2.03439 22.3894 8.18098 -13.9841 -15.6202 +1346 4 9.49692 3.09648 23.049 6.99386 -4.39158 13.7206 +1347 6 12.5495 20.2147 19.5723 7.26787 8.21028 -18.3895 +1348 4 11.6895 19.7983 19.735 -1.5185 0.18686 -8.43892 +1349 4 12.6119 20.404 18.6017 -2.05058 -6.51038 26.2392 +1350 6 53.8702 6.35891 18.9198 29.7306 -6.18586 8.10346 +1351 4 53.0457 6.06715 19.2818 -21.258 -2.7468 0.110915 +1352 4 54.4788 6.08079 19.6257 -1.29631 10.1734 -11.3531 +1353 6 1.76233 4.00968 13.2412 15.2049 -20.178 -6.82767 +1354 4 1.1126 4.5015 13.7221 -14.7745 7.27862 5.55391 +1355 4 1.46634 3.0803 13.3195 6.22895 8.64986 -3.00031 +1356 6 2.68809 16.4658 4.58471 15.0105 -8.44828 17.4213 +1357 4 3.47968 16.3912 5.17607 -18.0483 5.65918 -16.5792 +1358 4 2.952 17.0668 3.88721 1.61121 4.43717 -9.18758 +1359 6 22.6412 7.38905 35.0491 -42.342 -19.7774 -51.2585 +1360 4 21.8701 7.10292 34.411 47.7649 22.3984 34.2121 +1361 4 22.4927 6.7758 35.7601 0.300803 -9.30322 17.5195 +1362 6 30.6449 27.8966 19.9 11.2186 24.5725 -17.4668 +1363 4 31.067 28.6028 19.3405 -15.311 -24.4133 12.7333 +1364 4 30.0502 27.364 19.3383 6.18265 4.0422 4.40167 +1365 6 18.3584 9.54031 6.21119 11.0026 -3.68808 23.2716 +1366 4 18.3645 9.12256 5.3612 -2.33489 -5.22153 -19.3682 +1367 4 19.1216 9.13552 6.66909 -8.40358 6.03455 -2.63927 +1368 6 21.0207 30.3946 30.8361 -20.2261 -14.3153 8.76877 +1369 4 21.7305 31.0371 30.8947 0.539155 4.23503 10.2216 +1370 4 20.6128 30.1908 31.727 18.9681 11.2591 -24.4987 +1371 6 28.3223 4.36971 15.0862 0.785553 22.566 1.53388 +1372 4 27.9162 3.53142 15.2341 -13.4814 -22.4749 6.99245 +1373 4 29.0547 4.16931 14.5133 14.7433 -0.183871 -4.75122 +1374 6 12.7699 0.652736 16.5284 -10.9622 36.0111 -3.70833 +1375 4 13.1417 1.43405 17.0195 -7.22472 -23.339 -11.6266 +1376 4 12.1312 1.03058 15.8629 17.1298 -5.78525 17.4901 +1377 6 27.5613 35.204 8.24204 -17.5468 -3.17574 2.50179 +1378 4 28.0037 35.3359 7.41158 3.58667 2.22765 -10.9792 +1379 4 26.8513 34.5538 8.04841 12.0719 12.2779 8.55847 +1380 6 24.0727 5.16129 41.0114 25.3265 34.0312 4.62534 +1381 4 24.5764 6.00631 41.0278 8.83913 -22.6202 16.662 +1382 4 23.4512 5.41721 40.3589 -27.9927 -11.5371 -21.4854 +1383 6 16.8577 24.9409 28.3044 -13.362 20.9446 -8.34262 +1384 4 15.8529 24.9248 28.4711 42.0709 9.51562 -15.4474 +1385 4 17.0929 25.6637 27.6385 -20.1406 -20.6283 22.1367 +1386 6 20.8367 12.7872 17.016 48.1357 -13.7972 -0.957512 +1387 4 20.9831 13.7012 17.3244 -4.24853 -6.44611 -2.53838 +1388 4 21.7731 12.3998 16.8344 -46.2893 13.5674 8.59046 +1389 6 35.7698 23.0286 30.9167 1.31549 -8.15919 10.0357 +1390 4 34.8007 23.0783 30.9694 4.38358 -0.634017 0.107585 +1391 4 36.0504 22.6611 31.7855 -2.79806 7.45108 -14.1947 +1392 6 36.3049 21.4 25.8723 16.8231 15.2703 -10.059 +1393 4 35.3849 21.2313 25.7163 -23.5769 -6.11261 -4.10927 +1394 4 36.6855 20.6326 26.2849 5.24534 -13.4215 6.45433 +1395 6 13.4896 6.74946 5.28081 -28.3592 57.2786 25.4238 +1396 4 13.8414 6.02988 4.86679 44.4058 -71.9847 -33.7479 +1397 4 12.7199 6.9047 4.75258 -19.8414 9.95147 -1.72496 +1398 6 20.8046 20.4221 13.7595 5.24729 11.8597 -23.4966 +1399 4 21.3314 20.3763 14.5586 1.04488 -1.4591 8.76088 +1400 4 19.8874 20.2651 13.9627 -8.54986 -4.70556 7.47732 +1401 6 20.3763 29.1306 1.39291 -22.654 9.61717 24.1604 +1402 4 20.4714 29.8874 2.01179 2.99602 -8.49852 -9.62387 +1403 4 19.4639 28.7985 1.61052 22.0838 3.18086 -13.1329 +1404 6 50.878 13.1268 37.2744 -6.92527 18.9089 19.2141 +1405 4 51.431 12.5903 37.8743 -5.40112 9.96959 -2.47836 +1406 4 50.5327 13.8902 37.8162 10.8793 -23.2499 -13.6212 +1407 6 33.933 34.1706 20.4988 -24.935 23.2996 -4.02345 +1408 4 33.9537 34.3969 19.5503 3.97405 -5.2202 10.173 +1409 4 33.1424 34.6907 20.8306 20.6842 -17.0796 -4.50693 +1410 6 26.2139 28.0427 27.5441 -18.3219 -6.87449 2.92541 +1411 4 26.6233 28.4264 28.3298 2.52406 0.509022 -5.28732 +1412 4 25.2474 28.0355 27.7473 15.6982 -2.70826 -9.65401 +1413 6 7.68199 21.3044 4.2899 -23.4352 7.97399 30.3744 +1414 4 8.39223 20.9571 3.80392 40.3202 -21.1106 -20.5498 +1415 4 7.23721 21.8696 3.67656 -12.7303 12.1883 -10.427 +1416 6 21.997 15.1678 5.91921 0.156106 10.1967 -8.47357 +1417 4 22.4631 15.3078 5.09012 1.49736 10.8302 -2.43488 +1418 4 21.9323 14.2285 5.99467 -4.63281 -19.7734 10.7123 +1419 6 21.7161 24.0028 3.81129 14.7157 -6.77156 -2.79544 +1420 4 22.6514 24.278 3.99089 -16.266 -7.57571 -5.80044 +1421 4 21.7278 23.1773 3.27349 4.3704 10.7286 8.25651 +1422 6 11.5654 23.7677 12.5675 4.34126 23.9889 5.0328 +1423 4 11.8179 24.711 12.3772 -5.51197 -27.812 -0.203907 +1424 4 11.194 23.7871 13.4529 -2.51135 -1.17837 2.27349 +1425 6 32.365 18.0609 29.8133 5.42876 1.07285 10.0727 +1426 4 33.2855 17.8495 29.9872 2.18588 2.92383 8.75228 +1427 4 32.2516 17.686 28.9464 -9.45666 -7.03173 -17.6671 +1428 6 9.26057 12.3901 30.3108 6.69251 -5.93803 -6.45383 +1429 4 8.9331 13.0089 30.9751 -1.99931 -0.452864 0.983921 +1430 4 10.127 12.0766 30.6488 -15.6011 7.03664 -5.16285 +1431 6 40.1575 25.9297 9.14135 -21.3024 -7.39617 3.31146 +1432 4 40.7828 25.2448 9.36979 6.64832 -8.60816 0.262948 +1433 4 40.6901 26.6937 8.96671 10.3695 18.4246 -3.8085 +1434 6 43.1786 32.337 37.3292 -33.551 -18.2832 -9.28851 +1435 4 42.7165 32.8749 36.6701 14.8891 8.67062 4.46068 +1436 4 42.4294 31.7351 37.5575 24.0939 3.67107 5.33039 +1437 6 44.0961 6.28371 31.2632 9.51948 -8.69332 -33.5784 +1438 4 43.4914 6.92213 31.6058 -15.4833 19.2503 12.9198 +1439 4 44.559 5.89005 31.9835 8.76633 -8.79917 23.1113 +1440 6 10.2083 18.8859 19.6919 15.5822 -2.80816 -8.35433 +1441 4 10.2079 18.3466 20.4907 -1.18434 0.124911 0.125127 +1442 4 9.35433 19.315 19.665 -12.7717 3.54701 3.24565 +1443 6 7.05259 15.5816 15.0277 -11.6868 16.7681 -20.4125 +1444 4 7.21112 15.523 14.0697 -0.749561 -1.2692 3.08306 +1445 4 7.39122 14.7797 15.3874 7.84577 -24.8334 9.86289 +1446 6 24.5366 3.48359 27.8583 16.7503 5.69766 5.18976 +1447 4 23.7024 3.43271 28.3539 -4.73503 -2.50774 -10.2909 +1448 4 24.4259 3.10654 26.9763 -12.6917 -5.22111 2.5626 +1449 6 54.3931 31.8073 9.72289 -3.19054 17.1237 19.0803 +1450 4 53.9641 31.62 8.89214 -6.37727 -2.00813 -13.4715 +1451 4 54.1243 32.7301 9.92854 3.65429 -15.124 -2.64791 +1452 6 6.79493 17.0949 36.2025 -8.81624 7.47492 14.5397 +1453 4 5.9165 16.6466 36.2092 18.1356 5.91394 -12.2869 +1454 4 7.21103 17.1598 35.3293 -13.3551 -7.88765 -1.67162 +1455 6 28.633 7.46221 20.4165 -21.0133 14.9556 -29.8407 +1456 4 27.7506 7.6389 20.7846 4.83271 -6.12746 3.71795 +1457 4 28.5316 7.77661 19.4783 9.56717 -7.40103 22.9991 +1458 6 17.0376 1.7027 8.35788 5.34968 28.5352 32.0038 +1459 4 17.0661 0.753124 8.28199 -2.4228 -14.8367 -20.8379 +1460 4 16.762 2.22772 7.59129 -1.56258 -15.3605 -8.12812 +1461 6 19.1384 19.3343 35.5751 19.5023 3.30605 7.15282 +1462 4 18.4451 18.7061 35.4179 -10.2251 -8.92118 -4.92207 +1463 4 19.8852 18.808 35.914 -3.54436 4.66685 -0.605832 +1464 6 7.31639 31.3666 13.5695 -43.9944 -20.214 -21.2721 +1465 4 6.78612 30.574 13.8569 21.4883 17.7075 -0.698983 +1466 4 6.68503 31.7843 12.9295 22.0056 -0.349161 9.64417 +1467 6 16.674 5.24419 12.8556 -11.0373 -33.5815 5.02698 +1468 4 17.465 5.75961 12.9546 20.2971 3.5869 6.63236 +1469 4 16.7677 4.34295 13.2785 1.53127 21.9447 -10.2143 +1470 6 43.8803 12.7494 34.5747 -22.4085 -20.9808 -0.0671255 +1471 4 43.9515 13.6536 34.2548 -4.30422 8.76569 -3.51904 +1472 4 42.9542 12.429 34.42 18.6754 8.57765 -0.433924 +1473 6 42.6607 36.4569 28.5239 -16.8168 -12.4187 2.20896 +1474 4 42.172 37.2929 28.6321 13.9601 -3.78206 -4.91178 +1475 4 43.5913 36.5775 28.2923 4.62592 13.2896 -0.105187 +1476 6 35.3772 15.0586 6.04009 27.912 48.9275 -7.18458 +1477 4 35.887 15.8982 5.7897 -19.1126 -32.2788 12.1212 +1478 4 34.8045 14.9281 5.27735 -5.52923 -7.04807 -1.55591 +1479 6 19.4078 5.85855 6.1829 -40.2001 -18.9085 -3.31614 +1480 4 18.5441 5.99364 6.63156 8.43156 -9.10613 -8.3884 +1481 4 19.928 6.53616 6.54489 31.8426 31.4232 15.0663 +1482 6 29.261 38.1682 6.98131 -37.2303 32.1811 -6.57247 +1483 4 28.4837 38.0966 7.57517 15.5489 -1.40449 -6.41795 +1484 4 29.8842 37.5088 7.21603 19.671 -25.1607 10.5683 +1485 6 19.357 26.1782 8.47801 4.74765 -18.9961 17.9486 +1486 4 19.3733 25.7814 9.38274 -2.97831 10.6699 -17.265 +1487 4 20.1618 25.7953 8.09114 -4.76457 3.34604 0.730176 +1488 6 4.92328 16.6713 6.1398 7.47336 5.27851 2.26954 +1489 4 5.50113 17.3858 5.8203 -2.76896 -2.40075 1.51866 +1490 4 5.42288 15.8417 6.02573 -4.96937 12.5626 -0.560722 +1491 6 6.06184 16.6875 28.0703 25.9558 6.64688 1.10321 +1492 4 5.15824 16.4097 27.9597 -16.212 -5.66481 -14.185 +1493 4 6.48748 16.8231 27.1848 -21.9791 -6.00697 19.2504 +1494 6 21.7362 29.3702 22.1089 -17.2737 20.913 34.8846 +1495 4 21.4452 30.3289 22.1112 6.19611 -27.0689 0.469942 +1496 4 21.3293 28.9728 22.9428 14.5469 12.9694 -26.9427 +1497 6 24.4985 0.540505 12.8515 12.2489 -9.36427 2.95715 +1498 4 24.0437 0.939092 12.114 -3.50986 5.42614 -10.4761 +1499 4 24.1106 0.99496 13.5957 -0.561841 3.41965 12.163 +1500 6 18.4019 28.2584 40.3145 -11.401 19.5033 -15.6681 +1501 4 18.3886 27.6361 41.0165 -1.05122 -20.6036 22.2694 +1502 4 19.1831 28.024 39.826 8.23901 2.08545 -8.43276 +1503 6 10.3826 17.4565 21.9113 1.92941 -13.2413 3.45357 +1504 4 9.8824 16.6205 21.8349 3.82121 7.52813 2.02092 +1505 4 9.93899 17.9725 22.5913 -5.82795 2.16988 4.16556 +1506 6 13.5489 13.3588 39.6353 11.9209 29.8927 39.0415 +1507 4 13.8427 14.2544 39.3649 -8.64321 -16.3346 -3.85104 +1508 4 13.5548 13.4385 40.6332 -1.97454 -11.1079 -31.9482 +1509 6 19.5449 26.0093 24.7389 -52.2633 13.2593 -7.73686 +1510 4 19.57 25.3975 24.0097 10.2262 -10.7296 -10.4349 +1511 4 20.3304 26.0184 25.2393 35.6126 -10.3894 17.1361 +1512 6 8.93096 25.8929 20.0882 -7.71251 -64.4566 3.30388 +1513 4 8.30787 26.3938 20.5887 -11.4685 32.8171 11.63 +1514 4 9.62246 26.3511 19.648 20.7791 34.2926 -13.3665 +1515 6 13.4555 41.2072 30.5108 -10.8988 -15.928 5.69795 +1516 4 14.2767 41.1294 31.0436 -12.4449 -5.39064 -3.38157 +1517 4 12.7718 40.5451 30.8276 25.6688 18.9533 -5.69319 +1518 6 21.165 21.6707 11.1126 6.53241 11.8742 3.94385 +1519 4 20.8889 20.8699 10.6872 -6.5221 -17.8932 -11.6656 +1520 4 21.171 21.4318 12.0451 -0.673303 -0.892159 6.0991 +1521 6 43.5659 10.3222 15.565 -2.18625 -17.2881 -4.53442 +1522 4 43.269 9.50121 15.139 10.696 3.36153 7.59808 +1523 4 42.8911 10.937 15.2983 -10.0921 17.3133 -0.93945 +1524 6 23.5255 5.06673 12.3063 -8.27451 55.1521 -7.02327 +1525 4 23.4703 4.15364 12.096 -5.93718 -33.8878 -14.7403 +1526 4 23.077 5.57318 11.5535 15.1023 -26.9196 22.8331 +1527 6 9.29314 15.4001 4.25145 -3.86255 -4.02248 -25.5662 +1528 4 8.9509 16.1187 4.78154 1.1615 8.22379 13.6068 +1529 4 9.97933 14.9549 4.74249 8.84801 0.0887981 11.7331 +1530 6 26.7067 10.8779 17.5788 3.55047 -19.7627 -22.9275 +1531 4 26.5537 10.995 18.4988 -3.13636 8.79354 30.8805 +1532 4 26.79 11.729 17.1566 -1.16375 6.51516 1.16674 +1533 6 26.0497 23.6027 33.6801 19.5894 25.2732 20.1931 +1534 4 25.4452 23.9936 33.0304 1.52608 5.68176 -1.06817 +1535 4 26.6384 24.3139 34.1277 -30.0139 -24.8801 -23.6693 +1536 6 7.5709 10.5028 28.9083 -0.962228 -19.583 -21.6711 +1537 4 6.74329 10.4799 29.4005 3.80738 8.46019 8.36633 +1538 4 8.19878 11.0832 29.3397 0.629116 8.24646 12.7121 +1539 6 16.498 16.9072 24.6485 7.82025 23.6222 16.3151 +1540 4 16.0345 17.7596 24.5588 5.31695 -3.73313 -0.390286 +1541 4 16.1792 16.4208 23.9083 -7.11448 -16.9587 -21.9433 +1542 6 12.549 12.7866 0.448591 8.35618 6.39845 34.9671 +1543 4 12.9768 12.9146 1.38779 -15.5602 -17.6496 -50.0052 +1544 4 12.7689 11.9205 0.0349689 0.659473 7.36742 13.3893 +1545 6 6.80731 2.45617 9.05869 -7.23501 -7.03372 -0.578084 +1546 4 7.10343 3.02287 9.78944 7.77528 -6.31722 -2.26682 +1547 4 7.3272 1.63733 8.99034 2.01029 5.74015 6.94656 +1548 6 28.8877 11.8706 12.0154 41.6386 34.6329 -2.99516 +1549 4 28.2108 12.4771 11.6895 -6.34049 1.49886 1.56166 +1550 4 29.7533 12.3393 11.8008 -29.7579 -18.4108 8.17464 +1551 6 44.6745 32.5962 29.7139 -34.2161 4.66467 6.73964 +1552 4 43.7628 32.9784 29.4642 35.9402 -16.1761 10.2258 +1553 4 44.5125 31.9002 30.3967 -1.3182 18.2082 -15.8911 +1554 6 28.5995 15.1068 32.2872 13.2766 -51.3111 -20.1848 +1555 4 29.0279 15.8582 31.8991 2.31019 19.0875 -3.40369 +1556 4 29.0943 14.3419 31.8537 -21.7517 23.8731 20.1718 +1557 6 1.14062 22.1898 33.6289 -39.3586 14.574 19.5436 +1558 4 0.65227 22.798 33.0535 3.91391 -2.7929 6.08546 +1559 4 1.82717 21.8879 33.088 34.4042 -16.5957 -27.8984 +1560 6 17.4513 16.8201 9.93098 -1.82085 -23.3459 26.2514 +1561 4 17.8906 17.1746 9.18159 7.86355 15.3521 -22.135 +1562 4 18.0267 16.0779 10.2085 -7.73246 7.19916 -1.96586 +1563 6 18.7435 29.8048 14.4095 21.7061 -3.72347 40.0221 +1564 4 19.5652 29.5706 14.9087 -19.4331 3.67999 -8.42588 +1565 4 18.9661 29.6909 13.4944 1.97037 -1.23698 -19.2163 +1566 6 39.4071 6.51101 13.0179 12.0574 6.81682 -11.0022 +1567 4 39.7785 7.30288 12.5709 -10.193 -11.7897 7.6563 +1568 4 39.9532 5.78104 12.6849 -4.03584 4.98089 5.48617 +1569 6 54.0977 38.2821 14.3159 8.76467 -13.509 23.2458 +1570 4 53.5116 38.6447 15.0061 0.0542658 1.01747 -18.4972 +1571 4 53.8554 38.6311 13.4594 -12.9742 11.219 -5.93773 +1572 6 7.52036 32.013 20.9427 34.362 14.2167 21.5407 +1573 4 7.05735 31.9924 20.1252 -18.8869 -6.37038 -21.2822 +1574 4 7.04171 31.4816 21.5607 -16.1882 -11.3569 11.099 +1575 6 26.965 15.5039 13.8257 -10.8147 -22.3452 14.7237 +1576 4 27.2177 14.7358 14.3683 8.65177 6.42067 -5.59001 +1577 4 26.0429 15.6169 14.0906 -6.80859 9.66341 -6.51148 +1578 6 18.3782 16.4473 32.1249 -4.95226 -1.86998 -9.87987 +1579 4 18.1426 16.6374 31.1969 4.73263 -0.719504 8.39792 +1580 4 19.0836 17.0573 32.3614 6.73072 6.57595 -2.73442 +1581 6 52.4873 31.678 23.2415 -44.1119 -6.58328 47.4356 +1582 4 52.4708 32.2686 24.0415 7.23299 -8.75358 -21.8316 +1583 4 53.1739 31.883 22.645 31.3465 14.6123 -23.9869 +1584 6 2.16824 9.71317 28.2162 5.46837 -18.1801 7.45826 +1585 4 2.48183 10.5213 27.7929 -7.61484 8.72751 3.65687 +1586 4 1.37959 9.87032 28.768 3.44281 10.2362 -4.06622 +1587 6 32.9194 0.0905733 22.5781 10.5432 -20.5017 -7.42813 +1588 4 33.2395 41.1185 22.3208 -17.3926 6.61176 1.08087 +1589 4 33.7441 0.505918 22.8191 5.29332 16.1982 3.6992 +1590 6 20.7309 41.5697 38.6372 28.3147 -14.9122 -44.687 +1591 4 20.0328 41.0591 39.0281 -13.7779 -1.58578 11.2509 +1592 4 21.0348 40.9602 37.8857 -7.98591 29.4899 32.1121 +1593 6 43.3035 24.332 12.1458 11.7575 -1.61212 -4.71191 +1594 4 43.2118 25.2792 12.3722 8.64503 -11.1136 -9.01316 +1595 4 44.1249 24.1975 11.6011 -17.6772 13.9566 14.4164 +1596 6 22.028 36.2965 11.8178 -12.5217 11.0116 -6.64335 +1597 4 21.6755 36.9888 11.229 7.35556 -7.61462 10.605 +1598 4 22.8593 36.0261 11.4203 4.02803 -2.23458 -0.408194 +1599 6 50.7458 20.5312 30.3336 -27.3371 19.0798 0.575242 +1600 4 50.2829 20.0188 31.024 4.3389 0.549123 -5.17754 +1601 4 50.1148 21.2814 30.1453 20.3707 -20.1638 4.65154 +1602 6 20.8352 3.85006 18.1924 -4.58005 6.82859 16.651 +1603 4 21.6331 4.17131 17.7775 4.55578 1.29171 -4.07778 +1604 4 20.7516 4.34878 19.0287 -0.852135 -6.30171 -7.97465 +1605 6 4.00732 20.6422 6.98905 -51.5603 -31.2986 19.6291 +1606 4 3.1116 20.4695 6.56725 35.2765 12.481 -1.34365 +1607 4 3.83148 20.2497 7.8921 17.5771 16.9916 -21.2359 +1608 6 11.9503 15.4361 41.4392 2.8915 -19.3712 8.63656 +1609 4 11.9967 14.4718 41.7234 3.98465 29.7679 -14.4511 +1610 4 12.4631 15.5787 40.6176 -3.08486 -9.43894 7.49139 +1611 6 3.00006 18.5443 38.9307 7.29951 -23.84 25.6029 +1612 4 3.57591 17.7463 38.8471 -9.50595 12.5214 2.28144 +1613 4 2.93408 18.9335 38.0756 -3.85177 13.2219 -26.1975 +1614 6 8.60604 38.8696 11.3027 41.4164 30.2615 0.48057 +1615 4 9.41419 39.0226 10.7506 -16.8144 -5.25469 8.62565 +1616 4 8.21901 38.0768 10.9944 -17.9318 -38.1368 -15.4555 +1617 6 12.9777 33.9736 38.4849 13.2116 9.7409 3.49313 +1618 4 12.6169 33.1824 38.0476 12.8065 1.18326 0.516457 +1619 4 13.9558 34.0654 38.367 -20.6967 -9.66923 -0.235313 +1620 6 4.68265 11.9882 6.05233 -5.36104 -17.6375 -21.4001 +1621 4 3.82121 11.6194 5.80881 -7.3972 4.97776 10.103 +1622 4 5.22981 11.6659 5.30604 -0.806592 6.4598 12.5779 +1623 6 10.8388 15.9226 25.2234 -25.8257 0.885817 -3.68505 +1624 4 11.7194 16.2357 25.361 23.5714 9.8582 3.12124 +1625 4 10.3656 16.637 24.773 5.49819 -5.38784 0.449897 +1626 6 20.7519 3.25216 6.54608 14.2232 16.6176 4.63006 +1627 4 20.286 2.47445 6.25961 -10.3965 -11.4853 -2.16446 +1628 4 20.1859 4.03183 6.47283 -6.25253 -2.40724 -3.99784 +1629 6 47.6296 39.155 31.2075 -6.94169 16.2372 -29.2685 +1630 4 46.6717 39.1522 30.9686 19.778 5.05469 4.61154 +1631 4 48.0746 39.7923 30.5789 -18.3255 -25.0069 20.1215 +1632 6 8.32942 27.7692 27.6861 -22.9675 10.5768 13.2964 +1633 4 7.92083 27.0814 28.2574 8.55111 11.2092 -8.24047 +1634 4 9.05389 27.3382 27.2479 10.5137 -11.4359 -5.41666 +1635 6 33.26 40.3166 33.4176 17.9089 -0.14465 -4.13778 +1636 4 32.5337 40.9457 33.2593 10.2249 -4.59604 -5.86803 +1637 4 34.0027 40.4737 32.781 -17.2015 3.54767 8.86095 +1638 6 24.5063 34.6298 27.2698 0.491312 8.45089 -9.78892 +1639 4 24.8706 35.531 27.0561 -9.74802 -22.5685 0.190878 +1640 4 24.1 34.2837 26.4337 10.8101 11.1551 19.1745 +1641 6 13.3248 36.7606 35.7302 31.7841 1.54421 8.12469 +1642 4 14.2215 36.6075 36.119 -13.0291 10.9369 -8.07597 +1643 4 12.8242 36.0333 36.0767 -19.6956 -11.898 1.78685 +1644 6 34.0654 20.1519 33.2169 18.328 45.6356 -7.38724 +1645 4 34.7846 20.5927 32.7056 -13.2567 -20.8909 7.62801 +1646 4 33.6055 20.9496 33.5712 -4.62613 -21.3045 2.82084 +1647 6 22.8301 33.56 31.6141 4.86266 11.3389 -12.2002 +1648 4 23.5774 34.1707 31.5466 -2.83601 4.36281 -5.03091 +1649 4 23.1188 32.9172 32.2538 0.234413 -13.6868 11.6365 +1650 6 23.7437 2.42751 19.8437 5.37542 22.288 12.015 +1651 4 24.549 1.92657 19.7151 11.8542 -9.34304 -3.08207 +1652 4 23.0522 1.96699 19.3939 -17.1839 -15.7883 -12.7178 +1653 6 10.5922 1.64055 20.5239 -11.6119 -4.18685 -4.47424 +1654 4 10.0475 0.976152 20.0603 6.63037 0.339841 6.84259 +1655 4 10.5 2.45781 20.009 1.22375 1.55874 1.33627 +1656 6 6.49834 24.8637 7.80908 13.1619 -16.462 -27.2261 +1657 4 7.39752 24.8711 7.42138 -7.39511 8.18905 12.026 +1658 4 6.07255 24.1767 7.26903 -7.5733 6.7583 6.8074 +1659 6 54.7892 32.5297 25.4757 -1.36407 18.5665 -18.8778 +1660 4 54.0312 33.1434 25.3693 10.0694 -13.7478 6.1371 +1661 4 0.333918 32.6202 24.6425 -12.8409 -6.42816 22.883 +1662 6 6.2467 20.1884 28.9797 -14.5872 3.94595 -2.55046 +1663 4 5.42154 20.1642 28.4577 8.07739 1.90281 8.6477 +1664 4 6.84484 19.6236 28.4838 10.3646 -4.74821 0.341067 +1665 6 50.0565 21.6117 11.3373 -2.04109 28.5423 -29.4123 +1666 4 50.95 21.7264 10.9878 2.40449 3.31798 -5.14809 +1667 4 50.1463 20.9073 11.9368 0.900865 -33.3483 27.1981 +1668 6 43.4794 33.5181 19.6392 10.2306 -3.22473 -8.26676 +1669 4 43.7308 33.5714 20.5426 20.9097 -0.172793 18.6354 +1670 4 42.5556 33.6283 19.7345 -31.1875 3.87355 -8.92325 +1671 6 30.8203 7.18413 41.0653 -47.5647 29.7584 13.5959 +1672 4 29.9879 7.63165 40.681 33.629 -21.8567 10.9994 +1673 4 30.7637 7.50249 0.10761 7.36747 -14.0232 -31.1296 +1674 6 12.1328 25.8622 11.0863 -33.3162 -17.1307 -4.35232 +1675 4 11.2035 26.0164 10.7385 31.652 5.74526 10.6132 +1676 4 12.7063 26.6022 10.9281 7.22016 21.1466 -6.88425 +1677 6 47.8272 5.81934 17.7377 34.4122 -10.5063 -19.6374 +1678 4 48.0885 5.28838 16.9377 -7.84164 17.03 17.5567 +1679 4 48.6906 6.1712 18.0872 -20.5621 -5.0871 -4.09565 +1680 6 35.1646 12.9005 16.5891 -8.94037 2.15609 -8.82704 +1681 4 35.428 13.0005 17.5199 -6.39768 8.78744 -5.13392 +1682 4 34.5308 13.6301 16.3523 17.2323 -15.7422 12.9621 +1683 6 10.4611 10.6156 33.9687 -31.8989 -9.58391 14.7288 +1684 4 10.7981 11.3375 34.5166 5.24051 -2.75865 -7.26377 +1685 4 9.62118 10.4004 34.4306 17.5569 -1.50819 -12.473 +1686 6 9.86916 7.4616 9.67483 -1.17411 0.415312 -19.5192 +1687 4 9.17172 8.12646 9.7346 0.921409 2.8109 10.1471 +1688 4 9.97058 7.3459 8.70248 1.1017 -0.154201 19.4763 +1689 6 11.1489 9.5612 29.1408 -3.50418 -13.4139 2.93109 +1690 4 10.6848 9.26325 29.9428 4.68224 5.10434 -5.79998 +1691 4 11.3989 8.73954 28.6776 0.998479 5.88331 1.3781 +1692 6 46.4028 12.7539 37.8993 8.34964 0.221 -8.93676 +1693 4 46.6625 12.9969 36.9769 -3.46511 -1.57209 17.4302 +1694 4 46.8246 13.3669 38.5286 -1.63466 -3.53539 -5.22058 +1695 6 4.76485 19.028 16.0085 -13.5875 12.8334 -9.71245 +1696 4 4.2246 19.0797 16.8211 14.4547 -7.44532 -2.23877 +1697 4 5.5965 18.5831 16.2078 1.83868 -2.3176 10.3072 +1698 6 50.2593 39.8135 19.3633 -11.209 7.32279 -16.1387 +1699 4 50.2357 39.0929 20.0186 -9.83071 -0.813057 -10.1916 +1700 4 49.5811 39.7404 18.6324 20.3589 -6.83946 23.6454 +1701 6 3.57863 23.2976 26.309 -19.8478 3.89203 -2.42552 +1702 4 2.95325 23.1663 25.5593 11.1236 -1.69658 12.5574 +1703 4 3.09228 23.9147 26.9028 8.7219 -10.8877 -9.85517 +1704 6 43.325 18.2347 20.509 -6.81505 -1.42332 -3.46621 +1705 4 42.8171 19.0284 20.7204 1.20306 1.51529 1.23812 +1706 4 43.8577 18.0426 21.2915 2.12676 -2.58083 4.4502 +1707 6 14.5031 41.5275 19.7277 -3.40329 -5.13047 -40.8094 +1708 4 13.9246 41.7804 20.437 0.184992 5.83632 25.1113 +1709 4 15.42 41.4218 19.9774 10.3149 -1.62678 14.571 +1710 6 29.2836 29.8681 26.9083 14.7251 3.00272 -32.0725 +1711 4 29.2754 29.741 25.8744 6.18055 14.2787 56.2455 +1712 4 30.1283 30.2623 27.2985 -22.384 -15.5718 -22.4063 +1713 6 6.3217 26.153 11.5726 -10.9318 2.11689 -6.65038 +1714 4 6.21736 25.7454 12.4421 7.16784 6.77942 9.71283 +1715 4 6.96084 26.8819 11.5675 -0.124344 -5.20772 8.78036 +1716 6 27.6636 9.22988 15.2432 27.2347 15.0341 -6.49447 +1717 4 28.4103 9.83484 14.9873 -20.1055 -14.3916 8.85848 +1718 4 27.7674 8.48088 14.6445 -1.45999 -3.40178 1.02673 +1719 6 29.7804 38.0662 17.0819 -1.94795 -3.59677 -9.66723 +1720 4 29.6031 37.2203 16.6025 -2.55573 18.1678 4.54076 +1721 4 29.1155 38.7497 16.8561 3.55432 -16.3657 1.57327 +1722 6 52.2257 28.7184 4.26028 43.5541 11.735 -13.9492 +1723 4 53.1498 28.7813 3.86382 -28.9168 1.3453 15.0129 +1724 4 51.9642 27.8111 4.13511 -4.98861 -18.1961 -3.0857 +1725 6 17.1716 16.6708 6.09349 0.800403 22.8617 11.3476 +1726 4 16.9906 17.4665 6.64994 5.32834 -8.85643 -15.9231 +1727 4 16.9912 15.9587 6.69883 -0.0606397 -19.1034 5.18453 +1728 6 36.6551 7.54529 33.4256 0.520164 -21.8515 26.6937 +1729 4 35.9994 7.02185 33.9501 8.71508 10.7979 -12.9224 +1730 4 36.139 7.85703 32.6949 -12.9525 8.58568 -17.7829 +1731 6 26.1712 3.13186 9.59195 18.1066 21.2961 -28.5304 +1732 4 26.5502 3.5196 10.357 16.0028 12.4994 23.003 +1733 4 25.6506 2.45477 9.93435 -32.3265 -38.1289 14.2303 +1734 6 1.19956 17.1196 33.1708 -2.2935 18.3305 -9.07621 +1735 4 1.01553 17.8006 32.4822 1.56489 -10.8534 12.1427 +1736 4 0.844206 17.4429 34.0214 2.04572 -1.59411 -6.06332 +1737 6 29.1739 10.178 5.37516 -2.40587 -18.3881 11.7134 +1738 4 28.5386 10.354 6.08377 0.376669 4.93981 -3.98875 +1739 4 29.4881 9.26834 5.54278 -5.29161 7.67482 -7.40705 +1740 6 9.22817 21.1342 0.188585 30.2393 3.90367 9.01386 +1741 4 10.0008 20.6689 41.6954 -19.6386 2.89796 1.05729 +1742 4 8.40981 20.8027 41.7407 -2.68979 -7.66638 -7.21336 +1743 6 7.42006 26.8879 34.8536 3.14545 16.5486 30.4349 +1744 4 7.04622 27.0927 35.7464 10.1233 -6.04195 -26.4158 +1745 4 6.87255 26.19 34.5186 -13.4343 -18.5802 -10.0193 +1746 6 18.6153 10.1647 3.02259 -21.2705 37.3854 6.86975 +1747 4 17.9982 9.42011 2.89287 2.11135 15.8633 3.52195 +1748 4 18.115 11.0437 3.25865 19.508 -44.5053 -11.6159 +1749 6 13.1266 21.2208 25.207 -7.78894 4.80204 -7.88194 +1750 4 12.927 21.6586 24.3646 3.95449 -7.72121 4.87382 +1751 4 12.8054 20.3208 25.1571 -2.69895 -8.80511 -3.48609 +1752 6 4.90585 24.4116 40.531 -24.4864 -14.2944 -35.1794 +1753 4 5.64285 24.6041 41.0938 21.6142 3.21823 7.1591 +1754 4 5.22115 23.997 39.6806 -3.1008 12.4445 27.1665 +1755 6 54.7234 6.29054 9.93868 16.9838 3.76988 -11.4262 +1756 4 54.1595 6.0167 10.6465 -16.0707 -8.53288 16.3243 +1757 4 -0.00708757 7.17696 10.1972 2.88265 8.42125 0.296955 +1758 6 51.7481 16.6603 19.3703 -0.380283 5.87397 -29.4424 +1759 4 51.6376 16.2748 18.4816 -6.94363 -1.60509 11.109 +1760 4 52.3909 17.3585 19.2003 6.35466 6.30558 5.78841 +1761 6 38.6244 2.9738 13.1093 11.8256 2.30897 44.7329 +1762 4 38.5518 3.44318 13.9917 -0.399232 -9.9856 -23.4333 +1763 4 38.2423 3.54447 12.4592 -11.1085 17.5319 -17.0773 +1764 6 19.4422 35.7095 9.59568 3.40577 -0.828385 -4.73593 +1765 4 18.7414 36.105 9.07989 -9.16576 -3.00828 -7.06541 +1766 4 19.0009 35.4265 10.4088 3.97598 4.46758 -4.25365 +1767 6 46.943 37.6271 25.6985 10.3793 1.77648 -5.56802 +1768 4 47.12 37.9785 24.823 -9.34628 8.6078 -10.4475 +1769 4 47.7536 37.1497 25.8683 2.27046 -5.59472 9.98269 +1770 6 20.0359 17.269 14.7493 3.99527 -1.04076 21.685 +1771 4 19.226 17.5112 15.2169 -1.54973 1.23777 -13.9596 +1772 4 20.6203 17.0021 15.471 1.89523 -0.789097 -10.2839 +1773 6 24.7462 29.2867 3.75843 -10.1451 -8.18783 10.4774 +1774 4 24.6712 28.3277 3.51733 13.2212 23.8029 -9.5704 +1775 4 25.3186 29.8222 3.19111 0.258423 -15.3949 -10.1904 +1776 6 3.43 8.91865 6.82525 30.9316 4.78471 42.1024 +1777 4 3.12906 8.84201 7.76799 3.51474 0.65101 -30.0512 +1778 4 4.4001 9.15772 6.93718 -35.8795 -6.21414 -10.2854 +1779 6 17.4867 30.5875 19.7089 25.363 -13.1809 -11.8275 +1780 4 18.4189 30.3609 19.3993 -33.7851 8.31766 10.936 +1781 4 16.9116 29.8624 19.4038 1.038 7.7974 -2.73085 +1782 6 13.2718 16.1862 39.0546 8.76191 -18.4723 6.03369 +1783 4 13.8233 16.8904 39.4031 3.30361 7.54485 1.72389 +1784 4 12.5422 16.5765 38.5789 -11.7633 13.4881 -8.40344 +1785 6 23.832 27.9756 11.5898 -7.03122 5.38421 -2.05105 +1786 4 23.0756 27.4469 11.9259 8.81977 12.3317 -3.01362 +1787 4 23.7182 28.9056 11.8688 -5.28793 -12.9553 -0.41204 +1788 6 14.4579 24.426 21.2343 -3.66896 12.863 -1.79834 +1789 4 13.9584 25.2806 21.2855 7.33453 -15.5065 2.73981 +1790 4 14.2661 23.9117 22.0367 -3.91682 9.90798 -0.991428 +1791 6 46.6073 15.1543 22.2965 -20.8333 -3.77381 -11.8272 +1792 4 45.9584 14.6421 21.811 -6.87655 -3.95362 10.1018 +1793 4 47.2458 15.2644 21.6001 24.1162 10.8017 0.759212 +1794 6 19.1409 29.7195 11.8497 24.0494 -34.2428 10.0272 +1795 4 18.8784 30.5975 11.5793 -19.1418 4.86007 -17.3781 +1796 4 18.6106 28.9994 11.4276 0.263541 23.8948 1.0376 +1797 6 36.9127 18.8084 27.6222 -22.9356 -21.6011 26.171 +1798 4 36.4352 18.471 26.8408 6.36827 4.7914 5.64024 +1799 4 36.536 18.2194 28.3533 14.6987 24.2872 -28.1415 +1800 6 35.8684 17.5378 25.4906 20.6945 -0.513689 -30.4481 +1801 4 36.5966 17.7728 24.866 -15.8574 8.27186 11.6809 +1802 4 35.9779 16.5759 25.48 -10.902 2.42848 10.2606 +1803 6 8.03691 41.9141 31.5248 13.0394 10.4535 -6.8036 +1804 4 8.57921 41.2412 31.9888 -13.1962 14.522 -11.1095 +1805 4 8.63283 0.684743 31.1326 -8.3799 -15.4286 7.32752 +1806 6 31.7059 34.8342 17.9371 1.99631 -25.0047 -8.79133 +1807 4 32.5911 34.4609 17.7211 -13.4776 12.334 6.09844 +1808 4 31.8527 35.7258 18.2497 13.1847 15.6537 3.27409 +1809 6 22.1093 41.055 5.1451 11.5479 29.9587 -53.8497 +1810 4 22.1004 40.5969 5.93279 -2.68624 -33.8843 55.363 +1811 4 22.7885 40.6204 4.60559 -4.38419 0.844423 3.37931 +1812 6 11.6153 5.16618 29.5584 -27.6475 13.1782 12.6346 +1813 4 12.1606 4.37097 29.6057 -8.91967 -2.9702 4.15115 +1814 4 10.7377 5.1092 30.0631 35.581 -10.2726 -16.0904 +1815 6 13.0239 9.45481 21.0754 -25.8377 -26.1508 -25.9824 +1816 4 13.6778 9.97234 21.4999 31.652 16.6928 15.5055 +1817 4 13.4195 8.72209 20.5617 -0.589626 12.3395 6.44381 +1818 6 12.4227 4.1736 0.163828 29.6522 45.8695 -12.8421 +1819 4 12.6651 3.77524 1.00427 0.341759 -1.42745 2.51987 +1820 4 13.0617 4.97102 0.020112 -31.9214 -41.0145 4.8633 +1821 6 45.168 14.6284 28.1023 4.783 -10.4532 13.0266 +1822 4 45.253 14.8969 27.1759 8.39119 -6.85383 -0.732919 +1823 4 45.9575 14.0916 28.3529 -13.3622 13.2892 -14.7888 +1824 6 52.571 19.2551 0.894665 -6.12931 -19.318 2.27414 +1825 4 52.6102 19.199 41.8388 0.592413 0.00811024 1.08479 +1826 4 52.8129 20.1442 1.11528 6.55776 18.4237 2.43046 +1827 6 0.161625 18.5694 30.5785 -3.0227 0.535636 4.36465 +1828 4 0.968981 18.7291 30.0798 6.18464 -7.16445 -2.53371 +1829 4 54.7907 19.4514 30.677 -10.8229 5.89199 6.00525 +1830 6 17.6528 28.1849 1.96402 -7.28907 9.7522 11.2687 +1831 4 16.9769 28.8628 1.74785 9.23997 -9.27082 -2.31394 +1832 4 17.6006 28.1534 2.93661 3.56557 1.38454 -8.44201 +1833 6 22.5099 30.1653 5.01109 -1.02808 20.8676 -0.473944 +1834 4 23.1753 30.1014 4.30975 -2.49536 -9.56192 4.09657 +1835 4 22.058 29.3206 5.04766 -1.45363 -6.71999 -4.50103 +1836 6 11.4023 8.80853 17.6459 -26.9993 9.53928 -4.75555 +1837 4 11.8645 8.1762 18.2108 15.3222 4.18532 1.52515 +1838 4 11.9865 9.48216 17.2519 4.47877 -12.4161 10.2871 +1839 6 32.2917 3.59674 26.8117 35.3382 32.7507 -4.14644 +1840 4 31.8458 3.34967 26.0065 -10.4154 -4.5889 -14.8452 +1841 4 32.8806 4.37505 26.5671 -21.1848 -26.3524 0.379863 +1842 6 26.835 37.1568 15.6529 -0.874066 14.8773 29.2405 +1843 4 26.7488 37.4766 16.567 0.376185 8.65421 -15.6923 +1844 4 26.6891 36.2303 15.7909 -0.851881 -23.4278 -14.9094 +1845 6 22.9473 3.40289 22.286 14.7574 -3.5158 -4.23343 +1846 4 23.2792 2.98888 21.4515 -4.53852 7.92848 16.4552 +1847 4 23.7307 3.68139 22.8048 -11.9145 -5.32443 -10.4265 +1848 6 14.6269 28.2214 5.19572 6.06687 6.51489 2.87291 +1849 4 14.1454 28.1555 4.36712 -3.39073 -3.27129 -8.45242 +1850 4 14.2747 28.9991 5.64824 0.61258 -1.12864 1.62503 +1851 6 20.2538 37.2031 16.5466 -28.2562 5.81675 18.2866 +1852 4 21.1004 37.4666 16.2032 21.0823 8.59207 -3.85991 +1853 4 20.0754 37.7549 17.3418 4.82626 -5.93036 -10.2325 +1854 6 17.9544 28.5616 23.889 16.4449 -8.57642 -4.83649 +1855 4 18.808 28.1928 23.5683 -20.3084 2.86715 8.85187 +1856 4 17.2559 27.9215 23.6535 6.51898 5.694 -2.26134 +1857 6 33.646 24.2349 25.2286 -4.54069 1.10679 -14.8717 +1858 4 33.6591 23.269 25.0602 3.54988 10.512 10.2941 +1859 4 34.0237 24.3938 26.1034 0.864522 -9.38336 -2.59148 +1860 6 9.98122 17.6138 2.21344 7.43797 -27.5786 -7.49496 +1861 4 10.832 17.5317 1.73219 -10.6429 3.93943 7.97636 +1862 4 9.86311 16.7639 2.69719 0.409905 15.8492 -4.6087 +1863 6 24.3357 36.801 8.92185 2.98992 -6.60779 12.1866 +1864 4 24.0742 37.6409 8.56425 -5.30422 15.3919 -5.44039 +1865 4 24.7315 37 9.77917 -2.43549 -6.6012 -3.30269 +1866 6 14.4004 4.29557 27.7519 47.583 -3.32523 5.14754 +1867 4 15.335 4.40276 27.3948 -30.4143 -4.44284 13.8265 +1868 4 13.81 4.42145 27.0177 -13.2435 3.17509 -11.8406 +1869 6 13.214 25.4576 35.3169 -22.1271 -24.6319 4.29258 +1870 4 13.1587 25.1592 36.2444 11.1778 9.47444 -6.90086 +1871 4 12.4637 24.9943 34.8985 11.1514 12.2923 -1.08233 +1872 6 43.7301 33.1781 24.4042 -1.93578 -20.5981 16.0744 +1873 4 44.3223 32.959 25.1725 -10.0543 8.3706 -19.7015 +1874 4 44.0713 33.9344 23.9169 6.22405 5.02536 3.22562 +1875 6 6.9686 30.4099 7.14637 29.0056 7.39031 21.9321 +1876 4 6.75777 29.9621 7.98042 -5.17066 0.417247 -5.37485 +1877 4 6.23168 30.2842 6.57126 -23.4728 -6.8193 -11.7975 +1878 6 44.4308 39.4237 21.7855 -4.33275 0.914597 7.54549 +1879 4 43.8654 38.932 21.1541 10.179 9.64354 2.62582 +1880 4 45.001 40.0603 21.3196 -6.51882 -12.4268 -7.79327 +1881 6 1.18424 16.4398 24.9903 -32.4903 25.5998 2.59769 +1882 4 0.976951 16.9992 24.2076 17.4753 -17.2203 8.72915 +1883 4 0.385168 16.6115 25.5394 23.4019 -14.126 -4.16352 +1884 6 8.17355 33.8284 10.6836 -2.7688 -6.92624 14.1509 +1885 4 8.34263 33.4451 9.83813 20.7133 -1.8248 -25.0865 +1886 4 7.32622 33.4212 10.8229 -22.0824 -0.650197 20.9959 +1887 6 45.3734 15.866 40.492 8.57481 -12.1553 -4.93844 +1888 4 44.519 15.6937 40.0698 -0.240559 4.546 7.41406 +1889 4 45.2892 16.6061 41.0987 -5.95018 0.957053 0.609678 +1890 6 38.79 4.28815 15.8976 0.37918 -2.10791 -10.8791 +1891 4 39.6838 3.98516 16.099 -1.14178 2.00828 6.51653 +1892 4 38.4576 4.71748 16.7012 5.69678 -4.45181 -3.36891 +1893 6 21.0946 9.20757 23.9781 -15.5567 7.8487 -28.256 +1894 4 20.9171 8.74785 23.1381 12.0597 -4.77706 12.6228 +1895 4 20.522 9.98378 23.8483 8.03519 -2.74416 16.612 +1896 6 6.47513 36.1489 20.0112 1.62078 -0.443995 1.26518 +1897 4 5.91587 35.3892 19.7749 1.1588 6.62155 -0.72477 +1898 4 7.29927 35.7814 20.3561 -3.99682 -1.77997 -1.59627 +1899 6 17.7466 23.4563 11.2529 28.5847 -29.2717 26.027 +1900 4 17.0283 23.9723 10.9251 -27.3158 17.875 -1.49359 +1901 4 17.6201 23.2782 12.2162 -8.22502 9.28058 -23.7318 +1902 6 2.23619 39.2644 23.5388 49.8561 -28.1857 -22.6679 +1903 4 2.97831 38.9599 24.1359 -27.9038 8.524 -11.8523 +1904 4 2.61824 39.0932 22.6246 -22.7997 11.7085 33.9524 +1905 6 21.7216 10.3211 3.08421 -18.2449 14.4951 30.0936 +1906 4 21.8041 10.0076 2.215 15.0715 -18.3252 -42.7176 +1907 4 20.7597 10.3501 3.18369 2.1836 1.89441 6.77029 +1908 6 13.3346 37.6456 26.8309 31.2085 -13.7023 -2.95714 +1909 4 12.8405 36.9633 27.2803 -9.16641 -7.21061 8.74396 +1910 4 14.167 37.1703 26.5501 -23.1686 18.0804 4.61389 +1911 6 45.6739 9.85296 8.82966 10.4005 6.57186 1.33947 +1912 4 45.3411 9.70411 7.93855 -5.0879 -2.60549 -0.62074 +1913 4 45.1871 9.30295 9.44221 -8.90854 -6.98805 -1.17873 +1914 6 39.813 32.3454 29.581 6.89703 -12.1014 5.95535 +1915 4 39.6485 31.4219 29.3549 -7.08038 -1.01192 -10.7476 +1916 4 40.3223 32.2375 30.3827 0.600223 8.34958 5.32896 +1917 6 39.1399 32.1558 8.97291 22.8595 -6.45003 -40.3239 +1918 4 39.6086 32.0592 8.09926 -10.5081 2.64219 35.3633 +1919 4 38.2198 32.2158 8.71089 -7.955 1.72328 8.07951 +1920 6 29.7568 11.3071 40.3305 36.1908 -28.2332 -10.1569 +1921 4 29.0987 10.6276 40.5022 -6.8613 -0.261357 1.73371 +1922 4 30.5966 10.7518 40.2867 -25.0211 23.0598 -1.19829 +1923 6 24.8367 19.8778 29.8512 -3.76004 22.8831 22.3698 +1924 4 24.8428 19.0032 30.2276 -1.20959 -17.1847 2.11456 +1925 4 24.5914 20.4528 30.618 6.24059 -13.3215 -18.0816 +1926 6 50.0702 29.4819 2.87168 7.70946 6.50978 -10.1722 +1927 4 50.8345 29.4231 3.46787 -5.92296 0.441099 -8.02421 +1928 4 50.4135 29.3271 1.96617 -11.3825 0.248157 19.2026 +1929 6 26.3309 13.2577 37.9673 -13.8105 -3.9786 -34.6653 +1930 4 27.2227 13.0528 37.6163 -4.21147 3.58808 27.148 +1931 4 26.2568 13.475 38.8976 18.37 3.27206 13.6317 +1932 6 24.3356 13.8068 16.1475 3.59325 -0.347239 -0.208698 +1933 4 24.7367 14.1162 16.9522 4.68271 -6.41054 14.6744 +1934 4 24.1923 14.631 15.6832 -6.43367 3.48529 -13.6665 +1935 6 21.9593 25.0956 8.01078 27.9223 3.76027 7.52529 +1936 4 22.6404 25.6041 7.51239 -14.7718 -5.75747 5.32796 +1937 4 22.4795 24.6555 8.71494 -11.0917 7.59151 -10.9937 +1938 6 50.1732 25.2931 29.034 -22.8769 -27.0861 -14.4889 +1939 4 50.9231 25.1249 28.4453 9.52927 7.92169 5.9345 +1940 4 50.3853 25.9631 29.6741 16.3661 14.9722 8.20298 +1941 6 23.1854 6.82331 7.6223 5.22953 23.7057 -4.54178 +1942 4 23.9785 7.3899 7.84298 -26.8007 -12.7469 -6.01791 +1943 4 22.4118 7.42329 7.468 18.2581 -13.076 4.30509 +1944 6 6.92213 5.8571 20.8332 2.72627 6.95854 -11.5419 +1945 4 7.54915 6.58218 20.6217 -11.8273 -13.0803 1.39721 +1946 4 6.56012 5.53917 19.9848 5.57208 -2.46181 7.62025 +1947 6 25.395 39.7583 23.949 6.36773 8.3837 -46.9746 +1948 4 25.6324 38.8356 24.0083 0.522678 -6.92882 12.1803 +1949 4 25.626 39.9451 22.9935 -8.38215 2.07882 31.2615 +1950 6 10.8464 30.695 2.12273 2.92699 -11.4721 29.0623 +1951 4 9.93667 30.8598 2.41274 2.41412 3.42254 -4.79395 +1952 4 11.0072 31.0743 1.26994 -5.60296 10.8359 -22.248 +1953 6 23.0784 40.5299 40.0517 -12.8303 7.3127 -19.6888 +1954 4 23.7801 40.7079 39.3995 -2.98216 -3.06267 5.67195 +1955 4 22.2752 40.9489 39.6621 13.0026 -6.04267 8.58422 +1956 6 29.2116 28.3822 37.564 -38.7174 33.0362 -17.1388 +1957 4 28.2182 28.3913 37.3962 39.4392 -4.09178 7.25715 +1958 4 29.4217 27.5495 37.9564 8.20519 -19.4736 9.10227 +1959 6 1.867 12.1738 18.0852 -6.50713 5.08339 -35.4355 +1960 4 2.57398 11.838 18.6163 6.10024 -5.16113 22.8519 +1961 4 1.13063 12.5086 18.5994 -2.48645 -2.83143 13.3981 +1962 6 35.8305 14.0949 8.56039 26.0881 18.3061 13.156 +1963 4 35.1714 13.4739 8.88749 -16.8661 -4.96187 -13.4504 +1964 4 35.7684 14.4109 7.636 -16.9096 -16.2229 2.78164 +1965 6 9.49198 39.8165 37.5846 25.5398 -19.6342 8.10058 +1966 4 10.4488 39.5668 37.3792 -35.3087 19.1509 -1.98674 +1967 4 9.11285 40.4907 37.0027 15.1686 -3.88151 -5.41116 +1968 6 3.54864 30.3444 19.2746 19.2588 -4.84534 25.5649 +1969 4 4.39288 30.8221 19.2218 -5.35887 2.33403 -8.35831 +1970 4 3.69938 29.8 20.0823 -8.98886 6.07327 -15.723 +1971 6 36.3172 32.3761 17.5568 -52.716 -14.5505 -10.7859 +1972 4 37.1181 32.7413 17.8285 45.3049 23.5946 19.1732 +1973 4 36.5447 31.7674 16.8589 0.0557097 -8.91784 -8.34906 +1974 6 22.0674 24.5243 41.4066 13.5104 10.4808 14.5301 +1975 4 21.9193 25.2614 0.114872 1.55544 -1.48024 -5.36737 +1976 4 21.3782 24.5469 40.7428 -11.5581 2.78113 -8.36201 +1977 6 45.7659 15.6016 11.6394 9.02046 4.78635 -7.96304 +1978 4 46.6299 16.0103 11.8091 -2.50167 -1.58301 0.968075 +1979 4 45.9087 14.6499 11.5698 3.7439 -8.72722 -0.994242 +1980 6 22.3679 20.3809 16.0361 -10.6504 -17.4294 -19.3744 +1981 4 21.763 20.3139 16.7773 -4.42579 5.53693 13.3566 +1982 4 23.0073 21.0579 16.2253 11.6801 17.1208 13.2616 +1983 6 25.8325 25.7487 18.9031 6.26908 13.5994 -10.9759 +1984 4 25.2398 26.4837 18.648 3.49723 -12.6326 6.8661 +1985 4 25.3435 25.2434 19.5576 -3.6765 -3.23145 -0.768961 +1986 6 35.3178 34.202 33.2905 -17.6504 -29.1706 1.13026 +1987 4 35.3983 35.1402 33.2641 1.24044 29.706 -1.15043 +1988 4 34.4344 34.0427 33.6774 7.05439 -0.467604 -1.03347 +1989 6 39.2901 17.1075 17.3833 -11.3112 -26.2042 -1.68945 +1990 4 39.9794 17.7123 17.5836 17.425 19.0869 4.79839 +1991 4 38.575 17.6263 16.9966 -1.50153 2.1098 -0.940241 +1992 6 0.398412 14.9432 21.7856 9.03058 1.70326 -1.90296 +1993 4 54.4474 14.9193 21.5731 -3.898 -0.019948 -1.7993 +1994 4 0.528431 14.174 22.3634 -0.170355 0.861544 -0.399335 +1995 6 15.987 23.2263 17.7743 4.36624 14.6934 -7.14303 +1996 4 15.4857 22.9799 16.9684 3.82047 1.22984 7.38673 +1997 4 16.1722 24.1939 17.7179 -4.44652 -15.4901 1.96988 +1998 6 5.24865 11.1141 17.5618 6.95422 37.8037 -9.42255 +1999 4 4.73778 10.3127 17.5906 4.69561 -15.2682 10.3552 +2000 4 6.07662 11.1201 18.0866 -14.6292 -19.4463 0.240297 +2001 6 9.34435 36.7122 13.2675 14.3848 -20.4853 -8.45434 +2002 4 9.62142 35.7704 13.1913 -3.31983 12.7393 -0.467066 +2003 4 9.65952 37.1602 12.4706 -4.49166 -2.86228 3.29419 +2004 6 25.4918 33.5767 0.585194 -13.2513 47.819 -13.0434 +2005 4 25.5067 34.5261 0.924259 2.87868 -31.0124 -5.96193 +2006 4 25.9276 33.0244 1.21144 10.5779 -12.847 23.4116 +2007 6 17.3034 24.3894 31.3332 -3.83374 11.0726 -5.16798 +2008 4 17.6693 25.1812 30.9068 -1.9735 -3.85303 -0.254684 +2009 4 16.6127 24.6926 31.9382 -2.66612 -1.73239 2.61398 +2010 6 50.552 32.7161 27.7939 3.69414 -2.86079 -12.6149 +2011 4 50.6897 33.0491 28.6758 -0.144502 8.45372 13.0825 +2012 4 49.6264 32.8868 27.6344 -12.0524 -1.73095 -4.05681 +2013 6 2.253 37.2274 16.11 8.45807 0.136394 4.49883 +2014 4 3.21927 37.2459 16.107 -3.10104 -5.97474 -11.5471 +2015 4 2.06307 37.5747 16.9848 -8.61924 1.9026 3.91491 +2016 6 25.7683 33.176 8.40354 -18.9203 -11.3347 4.07551 +2017 4 24.8717 33.1921 8.8134 13.9609 -2.48357 -8.81655 +2018 4 25.7602 32.4226 7.7918 -3.67744 3.53954 1.65329 +2019 6 24.768 7.83219 25.4219 17.632 21.1734 16.2998 +2020 4 25.4945 8.36147 25.0103 -20.1597 -14.0103 5.71998 +2021 4 24.2535 7.44908 24.728 -12.2137 -5.73332 -20.4071 +2022 6 44.006 27.3325 21.546 30.1554 -7.9652 -11.3918 +2023 4 43.2457 27.8583 21.7575 -19.7371 1.57643 -2.46296 +2024 4 43.7964 26.4976 21.0884 -11.5694 12.3441 5.98804 +2025 6 20.8391 32.0716 6.72617 12.9902 -8.35788 -26.5741 +2026 4 21.6065 31.456 6.61879 -16.2643 13.1482 10.0653 +2027 4 20.6646 32.3142 7.64123 9.40483 -3.67012 8.54308 +2028 6 0.615177 26.1024 3.99379 -2.52029 5.686 8.70358 +2029 4 0.872898 25.4419 3.3518 0.34785 -8.86692 -8.8337 +2030 4 1.24928 25.9906 4.70547 -1.00806 2.16518 1.82635 +2031 6 23.6932 0.22266 22.8575 19.6208 -9.09848 8.51526 +2032 4 23.2991 1.09802 22.9795 5.26519 -2.66393 -0.960482 +2033 4 24.6108 0.216177 23.2468 -26.6208 7.90328 -9.41734 +2034 6 35.6316 26.9489 6.47476 -11.9227 4.67096 -7.07616 +2035 4 36.2784 26.7656 7.18499 -0.847143 10.2035 -9.59556 +2036 4 35.6247 27.8854 6.12936 11.6979 -23.4314 22.5499 +2037 6 50.1669 7.09081 18.6924 -7.14542 -1.6973 -3.47771 +2038 4 50.8011 7.27946 17.9805 -1.08143 -0.293524 0.841141 +2039 4 49.7425 7.94753 18.8476 4.63932 0.367722 -3.05405 +2040 6 12.4741 14.8288 12.1922 -8.10271 -9.61402 10.4649 +2041 4 11.6958 14.4794 12.6802 13.1948 7.08912 -7.97814 +2042 4 12.1183 15.3251 11.4609 -4.91784 2.70917 -6.99785 +2043 6 52.4614 22.3688 36.3388 -11.0199 -17.3524 -23.0567 +2044 4 51.6251 21.9183 36.1306 -2.17212 11.6706 13.3338 +2045 4 52.9952 21.963 35.6316 8.38603 12.1418 11.4133 +2046 6 41.778 11.4842 39.1192 -2.94788 -8.5466 -71.3066 +2047 4 42.0712 11.6935 39.9642 18.9262 14.1801 48.2999 +2048 4 42.4688 11.7778 38.472 -13.5225 -5.5757 18.7019 +2049 6 13.7869 22.5139 39.1025 -32.0544 -7.10206 -10.9841 +2050 4 12.8164 22.2898 39.2995 40.1723 6.0649 -15.4789 +2051 4 14.0276 22.2847 38.1645 -11.932 2.241 24.8997 +2052 6 28.7471 19.519 21.8427 26.201 -31.4587 -3.42241 +2053 4 29.5077 18.8642 21.7553 -27.3151 19.4313 7.21597 +2054 4 28.709 19.939 20.977 -1.33904 3.86677 -3.41873 +2055 6 8.35104 21.6464 36.3873 -9.70021 11.1463 1.78198 +2056 4 8.59231 22.5715 36.3877 5.92817 6.74417 -5.91108 +2057 4 7.6521 21.6323 37.0621 1.10663 -7.27579 -5.05072 +2058 6 39.9466 23.9759 15.2079 21.5993 -7.98015 -41.1742 +2059 4 40.8727 23.6245 15.2724 -23.8836 11.1149 -0.884493 +2060 4 39.7538 23.9548 14.2182 -0.675121 3.14563 34.0025 +2061 6 8.14826 38.6974 22.5407 10.5164 -8.10765 28.5856 +2062 4 7.68497 39.3831 22.0542 -4.5186 11.15 0.90042 +2063 4 8.43687 39.0737 23.4204 -11.1896 -2.29822 -22.518 +2064 6 10.8609 20.1732 28.9608 12.8413 -0.923384 7.34695 +2065 4 10.0131 19.7426 29.0637 -5.9523 -4.47565 4.1188 +2066 4 10.8844 20.5008 28.0696 -0.703946 5.19258 -12.1525 +2067 6 36.9008 23.822 41.8156 -12.4363 21.7846 -10.0393 +2068 4 37.5711 23.2333 0.167128 40.9996 -19.7248 12.2972 +2069 4 36.1173 23.3131 41.9445 -23.6506 -5.40851 2.0223 +2070 6 23.7894 40.6868 33.3454 12.8596 -15.6087 -7.6142 +2071 4 23.0064 40.9655 33.8068 -12.9523 11.6172 4.83708 +2072 4 23.8763 39.7481 33.6232 3.5481 12.5289 -6.50269 +2073 6 4.67002 19.3025 35.4081 28.9654 -8.37802 15.8464 +2074 4 5.50304 19.0977 35.9037 -20.926 10.8248 -6.78781 +2075 4 4.54874 18.5079 34.879 -7.50763 -2.93955 -6.02594 +2076 6 9.44906 25.7726 10.897 4.32597 -4.58851 8.60165 +2077 4 9.18995 24.8319 10.8983 -5.5655 4.98255 -0.925486 +2078 4 8.69969 26.3126 10.6078 0.159443 -6.7376 0.514864 +2079 6 27.2776 22.4912 13.6121 -0.517147 -7.99313 -8.85992 +2080 4 27.155 21.7331 14.2088 0.0551372 2.14825 -2.63665 +2081 4 27.5226 22.1158 12.7439 -1.12325 6.52643 14.1544 +2082 6 41.0473 18.7721 23.2805 -1.65607 -7.19044 -7.91226 +2083 4 40.4257 18.2083 22.8124 7.09703 -3.21037 0.549063 +2084 4 40.4899 19.4448 23.6465 -2.2525 13.4867 10.2584 +2085 6 46.4847 28.3568 20.1596 21.4343 7.62243 20.4812 +2086 4 45.6558 28.0725 20.6313 23.6124 6.3397 2.68094 +2087 4 47.3103 28.4552 20.7557 -43.4876 -6.08109 -17.1535 +2088 6 14.856 15.3945 30.0569 12.1054 -1.48105 24.8406 +2089 4 14.6669 15.4041 29.1302 -8.67008 -4.83168 -20.7775 +2090 4 14.3859 14.629 30.4429 4.17574 5.50589 -6.96103 +2091 6 23.5299 24.7674 35.2089 8.01546 19.7663 24.3744 +2092 4 22.8065 25.3632 35.4756 2.8295 -9.26237 -7.23473 +2093 4 24.1647 24.8645 35.9517 -5.58112 -4.18239 -8.07128 +2094 6 19.8979 24.2128 28.4372 -8.55524 33.371 -10.5251 +2095 4 20.118 25.106 28.0235 -7.554 -30.7898 14.4583 +2096 4 18.9386 24.2465 28.5992 8.91169 -0.342387 -2.75065 +2097 6 45.9653 7.62821 20.2375 0.645938 -6.46631 40.9505 +2098 4 46.1455 7.81465 21.2011 -4.75538 -9.14986 -26.6761 +2099 4 46.2053 8.42523 19.7798 3.02803 13.7202 -10.1214 +2100 6 38.0274 12.476 8.2804 -12.7973 12.3245 -4.6187 +2101 4 37.3544 13.1993 8.5286 18.4233 -41.2645 -20.6098 +2102 4 37.689 11.8001 7.60922 -1.16355 31.2483 23.3325 +2103 6 46.9232 18.1908 8.45127 -20.6048 6.85227 14.7641 +2104 4 46.2435 17.4987 8.55233 4.56757 4.50302 -0.225601 +2105 4 47.4224 17.9381 7.68168 11.4282 -5.99968 -17.9171 +2106 6 10.854 13.9656 9.37577 10.6617 18.3473 -18.9154 +2107 4 10.3554 14.661 8.90618 -4.87744 -10.6328 11.7585 +2108 4 11.7492 14.0754 8.99486 -7.79483 -7.36366 10.4335 +2109 6 34.413 5.42618 14.0852 -12.6861 0.159125 26.6885 +2110 4 35.1199 5.9296 13.6715 10.4361 -4.78744 -13.6438 +2111 4 34.2786 4.53955 13.7091 11.464 2.02167 -7.62295 +2112 6 0.18261 0.234369 22.9555 2.77695 -16.1069 -0.480131 +2113 4 0.268342 41.6651 22.1144 -0.0234796 4.94264 7.55149 +2114 4 54.831 1.09037 22.7433 -8.12427 18.964 -5.90735 +2115 6 40.9343 30.5497 37.8912 -0.822728 -5.40818 -2.29365 +2116 4 40.0406 30.8803 38.1728 23.6728 -16.1598 5.2797 +2117 4 41.3254 29.8415 38.4693 -14.8835 20.0143 -6.13723 +2118 6 16.6534 17.3205 12.6874 14.7099 15.3782 -9.06546 +2119 4 16.1954 16.505 12.4572 -1.18797 -4.10455 -0.493236 +2120 4 17.006 17.6533 11.8352 -5.05849 -6.69802 12.8635 +2121 6 29.6898 5.4323 24.749 -0.0153423 -4.79708 -9.00604 +2122 4 30.3311 5.93507 24.2276 2.5605 1.293 3.45927 +2123 4 29.9547 5.54756 25.6733 0.859724 2.70473 -2.20341 +2124 6 49.8976 0.279 27.2063 11.3554 -10.6099 9.68168 +2125 4 49.8114 0.578981 26.2935 2.75523 0.634109 -3.06626 +2126 4 50.8097 41.8349 27.2847 -10.6363 5.42595 -5.44518 +2127 6 31.2372 31.739 15.2138 3.99594 22.7956 -4.27207 +2128 4 31.6256 30.8953 15.4507 4.79789 -4.71254 6.82751 +2129 4 31.9624 32.4004 15.1381 -14.4355 -14.737 3.33184 +2130 6 35.7805 24.1465 16.9504 11.9916 -3.59376 -8.04525 +2131 4 35.6914 24.9231 16.3572 2.28972 -11.6943 5.94213 +2132 4 36.6882 23.763 16.8157 -19.8391 7.30154 4.46135 +2133 6 24.2601 4.62781 36.7306 -2.73038 -12.1142 -21.0154 +2134 4 24.8177 5.17448 37.2794 5.25293 5.76293 7.44764 +2135 4 24.6802 4.67277 35.8537 -9.35577 -2.69704 9.81341 +2136 6 17.5719 12.8989 3.66466 27.7221 -13.8379 -12.2911 +2137 4 17.7111 13.5231 2.92461 -8.26776 -5.83385 13.2655 +2138 4 16.7968 13.1561 4.15408 -15.8703 8.33112 4.7305 +2139 6 4.16771 14.2922 18.2601 -1.91899 -29.1082 -10.1028 +2140 4 4.22837 13.3107 18.2109 4.90834 19.7408 -0.578384 +2141 4 3.27435 14.4381 18.5824 -9.9871 6.86755 4.44487 +2142 6 19.1699 36.8381 22.3902 -4.55286 10.0742 -5.97046 +2143 4 18.832 36.3461 23.1414 -4.92402 -9.67799 11.164 +2144 4 19.5712 36.1952 21.8056 6.33502 -12.5333 -3.55186 +2145 6 15.653 11.96 13.2084 19.351 18.6963 0.185202 +2146 4 15.6609 12.833 12.7547 -2.35489 -19.4305 9.56752 +2147 4 16.5767 11.8359 13.5469 -18.24 -1.16426 -6.81767 +2148 6 24.7461 21.9204 5.38797 -27.1503 3.38708 1.08719 +2149 4 25.0422 21.7466 6.29562 -9.42613 0.489783 0.293639 +2150 4 23.7615 21.7936 5.33342 31.5349 -1.60743 10.1723 +2151 6 52.731 18.5617 35.2291 -23.3227 -9.96089 -3.35821 +2152 4 52.3432 18.0885 34.4925 12.0283 -8.22578 -16.7439 +2153 4 51.9379 18.6142 35.7503 -4.18579 12.1235 24.3517 +2154 6 3.56339 27.2782 25.2861 -13.9068 -17.971 -11.9546 +2155 4 3.93933 27.1708 26.1554 6.48024 -2.07304 15.4908 +2156 4 3.97283 28.0403 24.8958 8.97188 17.1762 -5.24442 +2157 6 34.4703 32.9949 30.674 6.71734 26.132 41.1649 +2158 4 33.5303 32.9277 30.8218 -10.267 -13.4259 -20.1884 +2159 4 34.6757 33.5653 31.4552 13.6938 -14.1125 -21.2315 +2160 6 35.2703 23.7477 9.841 1.59588 4.98779 0.126485 +2161 4 34.557 23.9691 9.22977 0.987563 3.83206 0.754652 +2162 4 35.6213 22.923 9.5082 6.82753 -10.3388 -1.5208 +2163 6 42.4139 15.7114 8.97964 24.1102 0.334397 4.42901 +2164 4 41.6569 15.4185 8.4899 -23.1764 -3.9339 -8.15459 +2165 4 42.1019 15.9745 9.85446 -9.30455 -0.897043 1.06511 +2166 6 7.76859 28.8573 32.9442 -15.9037 16.0354 -10.4898 +2167 4 7.97908 28.1549 33.5519 6.36032 -10.9608 11.0673 +2168 4 8.54203 29.0732 32.4131 7.8922 -1.0693 -1.41065 +2169 6 17.6887 41.2397 36.4833 -13.2152 -10.2381 33.1554 +2170 4 16.9194 41.8027 36.6113 -2.7651 1.17246 3.809 +2171 4 17.9462 41.408 35.602 16.1966 5.46369 -29.7656 +2172 6 28.4973 24.2486 15.5471 -12.6583 -10.112 -30.4241 +2173 4 29.1017 24.9078 15.1992 6.65529 6.29726 4.69488 +2174 4 28.2904 23.7156 14.7389 1.39534 3.17619 21.4563 +2175 6 20.9519 16.2974 1.15248 44.1264 9.982 -6.69009 +2176 4 20.9895 15.4004 1.43432 -0.0798072 -22.9414 11.198 +2177 4 20.0538 16.5254 1.09156 -44.6028 7.62895 -2.50253 +2178 6 31.1717 40.7384 5.29995 -1.14335 -24.9234 -14.6262 +2179 4 30.3101 40.4535 4.98914 0.542473 -7.39845 -0.335603 +2180 4 31.0069 41.6267 5.54556 -2.10438 36.1837 12.2935 +2181 6 29.9172 24.7601 36.4536 2.52587 12.7881 -5.39704 +2182 4 30.4095 25.4459 35.9567 -7.35112 -4.48214 8.13095 +2183 4 30.0744 23.9625 35.9621 2.47343 -16.947 -5.4104 +2184 6 8.66853 31.0461 3.90506 3.77884 -22.5587 -9.29968 +2185 4 7.73756 30.8263 3.92016 -7.28297 1.54323 -1.95967 +2186 4 8.75192 31.9258 4.24445 1.80419 26.3875 10.0131 +2187 6 5.53845 32.6958 11.4143 8.71933 -16.8124 -2.49586 +2188 4 4.77303 33.2403 11.6664 3.11219 -11.1916 -2.75881 +2189 4 5.22904 31.759 11.32 0.456358 25.4252 4.80969 +2190 6 45.6505 35.4572 20.4414 3.44959 -7.44503 -2.03407 +2191 4 45.0984 35.4295 19.6379 6.4013 -0.712815 7.57821 +2192 4 46.1919 34.6303 20.4513 -12.6908 13.7486 -3.45541 +2193 6 19.5117 2.78375 9.7759 -32.3978 -9.59039 -17.0694 +2194 4 19.2358 3.70482 9.71872 -0.134373 3.8207 4.89971 +2195 4 18.7417 2.29322 9.36028 25.7327 11.9734 13.3495 +2196 6 54.9587 9.07031 10.9149 6.82732 -5.63024 12.2566 +2197 4 54.8294 8.9199 11.8667 -4.4018 -2.06217 -5.32285 +2198 4 0.663346 9.73371 10.8556 1.49355 -0.124783 -2.42855 +2199 6 21.0387 26.5729 14.7801 20.1883 -1.49652 -44.4677 +2200 4 21.3075 26.2685 13.8316 -13.9911 15.8829 47.28 +2201 4 20.1009 26.3915 14.9175 1.72514 -4.1332 -5.78598 +2202 6 14.1556 30.5195 27.5512 33.9559 3.86758 5.7066 +2203 4 14.6157 30.1887 28.3748 -9.20473 8.28645 -28.3289 +2204 4 14.8625 30.9321 26.9648 -24.7422 -11.1229 20.6028 +2205 6 29.8153 17.3336 31.0863 -17.242 12.2647 2.89366 +2206 4 30.6608 17.508 30.6961 22.1461 -2.37775 -6.86255 +2207 4 29.3509 18.1813 30.9961 -0.156979 -6.11616 8.89085 +2208 6 50.8803 17.2897 27.8178 -36.3925 19.5692 4.68662 +2209 4 49.966 17.6961 27.8739 30.6942 -17.822 -8.40051 +2210 4 51.3989 17.8346 28.4178 4.99425 -5.86793 -0.268148 +2211 6 46.2649 37.0836 13.9834 -5.2064 -3.89214 -29.9265 +2212 4 46.1297 37.5324 14.8008 -1.4234 12.1478 29.9589 +2213 4 45.6025 37.4999 13.3985 5.55615 -7.46483 0.310394 +2214 6 38.1938 37.2652 33.1426 -7.30823 -21.5307 12.8964 +2215 4 38.5245 37.3061 34.0621 0.43181 3.22683 -10.2889 +2216 4 38.5338 38.0078 32.6437 8.99657 15.0472 -1.17828 +2217 6 41.835 13.3432 31.1173 -10.6585 13.9874 21.8211 +2218 4 41.5818 13.8647 31.919 4.55225 -14.0949 -20.2689 +2219 4 42.3932 12.6177 31.4161 6.34511 -7.13184 -1.29627 +2220 6 46.8964 12.6581 17.833 -7.85032 10.4907 -16.4819 +2221 4 46.6484 13.6178 17.7542 4.08188 -24.8978 -7.40371 +2222 4 46.6377 12.1709 16.9987 5.46876 16.7046 19.0746 +2223 6 32.0579 10.0934 10.6503 -8.64381 28.9058 -4.43215 +2224 4 31.7849 9.65569 11.4853 0.173068 15.3159 -11.0765 +2225 4 31.7767 11.0763 10.6467 12.4785 -48.8318 10.7993 +2226 6 34.0094 11.373 6.75969 12.8388 24.8548 11.4886 +2227 4 33.4875 10.5861 6.69386 -15.1181 -21.0438 1.83339 +2228 4 33.7853 11.7772 7.62543 1.85262 -6.17932 -11.7084 +2229 6 45.3294 30.8612 19.494 8.3992 -12.4908 2.66791 +2230 4 45.3133 30.6326 20.4263 -2.2594 2.91399 10.7741 +2231 4 45.8271 30.1094 19.1443 -2.81922 5.63857 -5.34771 +2232 6 20.3557 0.57205 7.14927 -0.865045 4.87397 8.36509 +2233 4 20.1887 0.590785 8.10086 -2.30268 5.48708 -2.96522 +2234 4 20.2885 41.5556 6.94299 -1.24307 -13.5357 -7.1472 +2235 6 15.9783 39.4524 4.13892 -0.0151964 -9.48015 -5.29824 +2236 4 15.6158 39.9898 3.41173 1.6648 1.85694 12.5404 +2237 4 15.64 39.7774 4.99485 -4.20756 5.15612 -10.0141 +2238 6 52.4256 16.4667 25.1127 -17.0507 13.8269 -2.02364 +2239 4 51.8848 16.9346 25.7614 0.982734 -7.60925 5.82434 +2240 4 52.3383 17.0704 24.353 8.48557 -12.5426 -0.219872 +2241 6 38.5361 13.0039 3.23845 15.1533 54.069 38.768 +2242 4 38.651 13.64 4.04305 -2.16968 -28.4467 -44.0011 +2243 4 38.0019 12.309 3.58724 -16.6469 -22.8542 0.297491 +2244 6 35.13 29.6899 31.1766 -32.8294 1.63854 50.8714 +2245 4 35.4825 30.1651 30.4465 16.0479 15.276 -26.3528 +2246 4 34.6741 30.3613 31.7643 12.1102 -21.125 -19.7306 +2247 6 9.51973 33.7498 4.86217 -21.8826 5.77433 4.68556 +2248 4 9.27059 34.3826 5.57285 8.50621 -13.5655 -12.6408 +2249 4 10.3866 33.3952 5.041 8.90701 -1.44023 3.12186 +2250 6 21.534 22.0642 20.5279 -11.3341 -5.53839 17.2976 +2251 4 20.8989 22.7675 20.339 3.51908 1.76985 -0.685914 +2252 4 21.3133 21.7346 21.437 6.74336 6.48682 -22.5749 +2253 6 37.579 11.1901 41.2936 -40.5688 -13.8213 19.6839 +2254 4 37.9154 11.8125 40.6731 20.8822 18.4609 -22.3708 +2255 4 38.2848 10.6639 41.6667 19.2795 -3.39896 1.21846 +2256 6 33.8862 1.42431 38.7362 -9.76991 -12.243 -0.11253 +2257 4 33.6023 0.553369 38.4181 2.20193 5.31751 1.25532 +2258 4 33.9041 1.3558 39.7008 -0.574955 5.51976 -3.65617 +2259 6 4.57166 26.6812 27.9899 28.8485 -45.5436 -4.48952 +2260 4 5.15229 25.8908 28.1565 -23.3183 20.9594 -13.553 +2261 4 4.90489 27.293 28.6243 -0.866291 24.6335 11.5543 +2262 6 10.2514 0.902381 11.6154 -4.58149 -17.6537 26.8062 +2263 4 10.6592 1.12475 12.4668 -4.26503 -7.612 -8.38981 +2264 4 10.5004 1.60734 11.0484 5.83944 23.9466 -26.0443 +2265 6 17.6545 19.8255 2.35686 18.7122 -0.118329 6.29025 +2266 4 17.9031 20.43 1.64019 0.754008 -4.0492 2.7955 +2267 4 18.4832 19.3436 2.60738 -15.0404 10.1651 -4.64219 +2268 6 32.418 25.6758 16.4635 3.6076 24.4214 11.9097 +2269 4 33.0171 26.0095 17.1449 -9.06157 4.09224 -4.99535 +2270 4 32.7904 24.838 16.2462 -1.14602 -28.0291 -11.1265 +2271 6 33.2468 10.6359 0.32388 9.93322 -26.76 -6.12289 +2272 4 32.8861 10.0042 41.5485 10.341 19.2926 16.9559 +2273 4 34.0854 10.2367 0.697563 -23.7256 11.8288 -10.1734 +2274 6 4.94758 4.52061 10.1416 10.7499 4.98188 17.9077 +2275 4 4.04768 4.863 10.1726 -0.273394 -4.88493 2.42241 +2276 4 5.29522 4.53942 11.0694 -10.4701 1.63881 -23.2648 +2277 6 27.0943 16.9779 9.5563 -20.4641 3.47693 -11.2288 +2278 4 27.2045 17.5151 10.3493 -1.38601 2.5137 2.70549 +2279 4 26.2214 17.2494 9.17658 21.4447 -4.2653 12.7286 +2280 6 9.99194 10.5198 19.3763 9.42123 -1.05348 44.8422 +2281 4 10.4342 9.89794 18.8118 9.85784 -12.5922 -17.5865 +2282 4 10.1605 10.162 20.3013 -9.67835 15.4527 -31.558 +2283 6 19.5738 8.53792 27.8563 25.8928 -1.13542 15.4327 +2284 4 20.113 8.77024 28.6584 -12.6361 -5.62488 -23.922 +2285 4 20.1113 7.87775 27.3567 -13.5748 14.3815 9.08869 +2286 6 47.0629 38.9588 23.1271 -13.9792 1.44752 0.432651 +2287 4 47.6691 38.8737 22.3925 4.22694 -4.47738 -4.61135 +2288 4 46.1776 38.8683 22.7344 3.33277 3.24373 3.79368 +2289 6 19.6833 25.3678 11.2608 -44.4501 -0.725843 0.650565 +2290 4 19.0139 24.6272 11.3182 24.6346 19.551 -2.60477 +2291 4 19.1544 26.1629 11.5326 10.4738 -19.1562 -5.87093 +2292 6 27.3884 13.4531 15.7313 17.4935 -10.3398 7.87305 +2293 4 26.7289 13.8255 16.2909 -22.225 11.7393 10.4827 +2294 4 28.1076 13.2654 16.3619 5.43008 -3.78237 -14.8549 +2295 6 18.6476 14.1287 1.42435 5.12245 -4.46092 -43.403 +2296 4 18.3969 15.043 1.25229 -6.07889 7.26273 6.76186 +2297 4 19.169 13.9274 0.593091 -12.995 -1.5013 29.2583 +2298 6 42.2956 22.0175 32.4812 -31.5033 5.69606 -11.9689 +2299 4 42.0953 21.6028 33.3343 -5.26012 -0.0861087 1.91793 +2300 4 41.4492 22.4721 32.2087 27.3869 -15.7461 8.96812 +2301 6 10.0338 9.4525 2.5044 21.0744 -25.1182 9.26795 +2302 4 9.23419 9.82009 2.8603 -22.4046 15.9317 4.21557 +2303 4 10.2146 8.68383 3.09556 -0.513225 11.8796 -14.6695 +2304 6 6.81454 1.43994 21.9965 -17.8896 2.42247 -7.4431 +2305 4 5.91626 1.63042 21.618 24.8197 -16.2049 7.25345 +2306 4 7.09146 0.513113 21.8391 -15.5061 11.1514 -4.64506 +2307 6 11.279 27.0428 18.9739 -2.94846 37.5248 -0.887691 +2308 4 11.8405 27.0241 19.773 -2.49358 0.901506 -7.48985 +2309 4 11.2189 28.0198 18.7087 3.35633 -32.7966 13.2637 +2310 6 41.4624 20.5117 27.2131 -8.71247 23.609 -19.3396 +2311 4 41.6397 21.203 27.8749 -2.09795 -12.5822 -0.139714 +2312 4 41.4581 19.6661 27.6488 3.25287 -9.08293 14.2442 +2313 6 15.4472 24.107 33.4286 7.47915 5.78269 -2.8589 +2314 4 14.6947 24.3175 34.0087 6.10264 -6.26217 -2.67023 +2315 4 15.704 23.1687 33.5026 -8.54671 4.87938 10.939 +2316 6 36.1332 16.3778 10.0175 -2.81296 8.13669 8.31829 +2317 4 36.0433 15.4982 9.63146 0.0153009 -3.05325 1.23302 +2318 4 36.1908 16.2895 10.9807 1.05799 -3.5475 -8.17119 +2319 6 51.7056 16.2618 2.12066 8.195 -18.8618 -27.7488 +2320 4 51.3212 16.7491 2.82948 -13.5116 6.32013 30.1636 +2321 4 51.8333 15.3227 2.36395 -2.62212 15.8907 6.5854 +2322 6 23.4154 8.54771 39.774 19.4785 -4.07885 -14.0827 +2323 4 23.6619 8.92799 38.8876 -4.40964 -10.2511 30.1282 +2324 4 24.1933 8.06554 40.1323 -10.8686 15.1901 -10.9325 +2325 6 36.7652 34.4407 21.0996 -10.7203 -4.0633 -8.35763 +2326 4 37.1575 34.5988 20.2292 -2.24352 0.118594 1.89686 +2327 4 35.7922 34.4168 20.9564 13.0606 -0.027129 3.88767 +2328 6 14.1394 8.88964 27.2822 8.4001 33.0473 -16.3093 +2329 4 13.5583 8.17177 27.4325 -25.1847 -27.8879 6.89622 +2330 4 14.9981 8.62308 27.6007 12.278 -0.771553 4.38 +2331 6 20.6523 37.4857 25.1916 -4.76336 -9.80096 2.89409 +2332 4 20.8435 36.6327 24.7231 -2.60537 24.8018 1.29013 +2333 4 20.5883 38.2205 24.557 2.95927 -14.0914 0.587832 +2334 6 28.8259 24.466 30.0361 -12.0182 1.20484 18.6414 +2335 4 28.1863 24.5363 29.306 15.5663 0.0495978 -2.57679 +2336 4 29.6571 24.0617 29.7579 -0.701354 -5.27936 -13.535 +2337 6 8.3767 11.9994 23.6977 15.286 -11.9681 20.7139 +2338 4 9.3753 12.0245 23.8359 -31.6027 -4.22616 -3.50543 +2339 4 7.96209 11.4264 24.4013 16.8905 14.3689 -13.5243 +2340 6 16.0974 26.6628 22.9497 0.767107 4.93659 2.67852 +2341 4 16.422 25.9025 22.452 -4.69466 0.466105 1.02544 +2342 4 15.3072 26.4353 23.4595 5.90508 -1.9072 -2.1838 +2343 6 22.3492 41.3933 9.48833 17.1541 -15.2597 3.14364 +2344 4 22.6076 0.330473 9.13574 5.89797 15.5422 -4.87712 +2345 4 21.4389 41.4869 9.73785 -21.2641 2.73615 1.78898 +2346 6 49.3865 19.1849 32.379 28.5034 -27.5288 -8.8444 +2347 4 49.9591 18.5119 32.8294 -20.0237 22.3317 -7.01358 +2348 4 48.8882 19.6696 33.032 -5.7885 3.32597 15.4548 +2349 6 29.6797 28.4194 31.2347 -18.17 -6.54897 12.3532 +2350 4 30.6054 28.3362 30.9452 0.112823 -13.8933 8.50124 +2351 4 29.3632 27.6339 31.7874 27.6893 19.0339 -22.4607 +2352 6 5.1089 39.1304 23.5821 16.3589 -26.7425 38.52 +2353 4 5.38369 38.72 24.4786 -14.1195 25.2427 -41.8592 +2354 4 5.12138 40.0884 23.679 1.29424 5.88982 9.05127 +2355 6 42.9406 13.5828 41.5963 2.4548 -20.3274 5.45752 +2356 4 42.752 14.3543 41.1051 4.71299 30.6973 -25.311 +2357 4 42.1302 13.4831 0.159852 -12.9765 -12.2431 17.3873 +2358 6 21.226 12.4267 7.36435 31.2446 -3.521 -2.03074 +2359 4 20.2961 12.4647 7.18572 -19.4619 -2.59914 -12.879 +2360 4 21.5838 11.6146 6.96487 -5.92297 6.31526 1.33966 +2361 6 43.1402 26.8798 37.6925 36.8226 -18.0871 25.2922 +2362 4 42.3701 26.4861 37.2457 1.92095 -10.9538 3.42147 +2363 4 43.8051 26.2366 38.1772 -44.9135 25.1765 -29.4158 +2364 6 19.5374 10.6589 41.6895 -5.57828 -38.0023 -10.1688 +2365 4 19.1336 10.6448 0.637369 -6.5477 2.89313 17.0607 +2366 4 19.8005 11.5407 41.5226 10.6711 39.664 -4.3781 +2367 6 53.6211 10.0725 3.2523 6.57913 5.47914 -9.18923 +2368 4 54.2317 10.83 3.34927 -4.54537 -9.93589 0.0420736 +2369 4 54.0384 9.44833 2.62164 -2.29754 8.8252 9.03809 +2370 6 17.5636 20.1992 28.4305 -16.5699 17.1528 15.5915 +2371 4 18.0548 19.7019 27.7957 9.40873 -10.9714 -15.8242 +2372 4 18.1497 20.2955 29.1876 1.50874 1.07066 2.83373 +2373 6 36.8673 7.33814 1.69171 -42.7001 9.70605 -8.47937 +2374 4 37.6788 7.60022 2.09727 18.2611 10.2246 9.26811 +2375 4 36.4242 8.16776 1.39628 11.5951 -12.345 5.16871 +2376 6 29.225 41.4226 1.83075 -19.1389 21.107 -1.05665 +2377 4 28.4254 0.0289368 2.09685 16.3458 -11.1471 3.47601 +2378 4 29.1672 41.4088 0.871311 7.531 -2.47214 -5.14574 +2379 6 13.5148 3.09025 8.11784 -10.8355 13.5741 -3.86075 +2380 4 12.8447 3.80664 8.08285 8.27234 -10.6709 -2.48032 +2381 4 13.8247 3.09872 9.02804 1.30446 -5.60755 1.07776 +2382 6 15.035 29.5824 18.5052 -13.3664 3.09019 -9.07378 +2383 4 14.628 28.8743 17.9722 6.78876 3.62049 6.93265 +2384 4 14.2975 30.1967 18.6986 12.8362 -2.82157 -1.1162 +2385 6 10.5118 24.7077 24.3903 18.3301 23.9761 -31.3173 +2386 4 10.707 24.7057 23.4146 -4.2845 7.89501 28.372 +2387 4 10.0612 23.8909 24.4849 -17.9274 -27.8 13.6507 +2388 6 2.3293 13.8562 25.1542 8.14415 -2.44132 2.05706 +2389 4 1.63302 13.4321 24.6436 -3.32338 -7.08116 -5.4939 +2390 4 2.0923 14.7815 25.112 -7.52471 9.11743 -0.122921 +2391 6 31.8571 32.759 29.7983 3.65167 10.3578 -8.56752 +2392 4 30.9277 32.9381 29.9784 -0.622435 -3.80813 0.732423 +2393 4 31.8884 31.8723 29.4276 -3.71181 -5.10697 -2.58235 +2394 6 37.531 40.8209 33.967 -23.153 -16.1875 5.3836 +2395 4 37.3251 40.1347 34.6985 0.870468 26.6491 -35.3147 +2396 4 36.773 40.8784 33.3102 18.3716 -9.25033 25.8989 +2397 6 24.0485 38.1313 34.3431 -11.5105 1.837 -35.773 +2398 4 24.1907 38.198 35.2802 9.24451 -7.73664 19.5979 +2399 4 24.4675 37.3552 33.934 1.62169 3.10325 14.1331 +2400 6 37.1852 22.5711 7.36841 5.54302 -17.8805 15.7599 +2401 4 37.6193 21.7136 7.5635 -9.24307 15.2983 -3.07678 +2402 4 37.2973 22.7156 6.43503 3.10694 -1.55352 -15.3513 +2403 6 4.30637 23.241 35.6005 -21.8515 -3.12039 0.833232 +2404 4 4.28153 22.3978 35.1252 -1.17938 4.50836 1.52069 +2405 4 3.36633 23.5034 35.7569 13.5984 -2.36814 -1.35472 +2406 6 15.7372 14.8984 2.68389 5.83394 8.18523 30.6602 +2407 4 16.0581 15.8209 2.80401 -5.66096 -17.7803 -6.78984 +2408 4 15.4195 14.7671 1.79524 0.865375 8.28049 -11.4308 +2409 6 48.1667 23.1873 2.04358 2.14857 -5.2771 -14.5053 +2410 4 48.6748 23.4267 2.82287 11.4848 0.866046 3.26637 +2411 4 48.7964 22.9219 1.32588 -13.3162 5.875 14.6145 +2412 6 24.1221 19.9752 21.5371 -32.3717 23.6383 6.86593 +2413 4 24.143 19.3917 22.3107 11.6246 -2.80692 -10.3828 +2414 4 24.7866 19.7762 20.8968 22.5091 -14.1667 -7.68302 +2415 6 10.5822 29.3968 5.14403 -6.21678 -11.6361 15.7318 +2416 4 9.83188 29.7897 4.67624 10.1791 9.93667 -6.35089 +2417 4 11.4324 29.7717 4.90568 -2.60747 8.99296 -10.7541 +2418 6 5.96985 27.6957 31.2251 14.0826 -21.4471 -14.909 +2419 4 6.62108 27.1001 30.7651 -15.2176 13.0885 7.83628 +2420 4 6.49554 28.1541 31.8886 3.5811 4.10899 4.91189 +2421 6 18.524 25.7945 15.3346 -6.80319 -1.26411 -41.3947 +2422 4 18.3129 25.8537 16.2191 -1.03447 -6.47723 71.4836 +2423 4 17.8509 26.3975 15.0287 -5.96066 9.61194 -22.438 +2424 6 52.0911 37.2147 11.1191 10.7944 -12.7592 -3.2574 +2425 4 52.6735 36.5031 10.7991 -6.06835 6.24709 5.19982 +2426 4 52.6754 37.9802 11.2539 -6.64808 -1.57102 -0.449092 +2427 6 46.8545 14.6154 7.32174 -10.4102 9.08531 6.17155 +2428 4 46.1761 15.2305 7.76384 29.9054 -34.6086 -7.32766 +2429 4 47.196 13.9114 7.91569 -13.0839 18.0399 0.731203 +2430 6 22.2426 0.701706 41.6733 41.1626 12.534 -29.9538 +2431 4 22.236 1.66756 41.6378 -9.79705 -6.68715 4.90956 +2432 4 23.0808 0.492341 41.1545 -29.2322 -0.545859 23.5967 +2433 6 4.06645 14.7285 9.26505 -5.79968 22.7562 -12.5209 +2434 4 3.53709 15.5501 9.07402 9.13976 -21.8289 3.48331 +2435 4 4.94549 14.9564 8.94351 2.1847 -1.50717 0.750146 +2436 6 37.293 12.6643 37.0348 -15.3153 -6.18171 16.0178 +2437 4 37.7524 12.8164 37.9019 -17.8573 -2.14895 -9.99561 +2438 4 36.3666 12.3049 37.1727 33.7628 8.85249 1.83374 +2439 6 26.6624 29.0693 40.5955 -26.637 27.4899 13.7151 +2440 4 27.0962 28.2693 40.8235 19.1059 -29.7051 -2.9078 +2441 4 26.7436 29.2635 39.6647 9.93266 -1.33043 -11.4317 +2442 6 7.23743 13.8563 3.32048 -33.1041 -30.3754 -14.41 +2443 4 7.96064 14.4301 3.56742 25.5688 -7.52041 0.820923 +2444 4 7.42976 12.8854 3.09984 6.81051 43.2082 15.4509 +2445 6 8.94797 34.8532 28.8254 23.4184 -23.2786 -12.4265 +2446 4 9.89546 35.0323 28.6727 -12.7097 -5.00209 3.03018 +2447 4 8.59604 35.6886 29.0779 -14.3686 23.8739 12.2374 +2448 6 37.2014 40.0808 40.1141 12.7521 0.43192 13.6168 +2449 4 36.2619 40.0837 39.9632 -10.4254 2.72875 -6.67898 +2450 4 37.248 39.4512 40.8496 7.71934 0.19736 -2.65382 +2451 6 30.3728 6.17428 27.2502 2.34222 12.9127 24.6773 +2452 4 30.0491 5.75377 28.1093 17.5599 21.8776 -23.7977 +2453 4 31.0277 6.90628 27.4549 -18.5498 -22.5685 3.02853 +2454 6 10.4851 22.8816 18.2947 -6.39025 -14.7202 -25.3901 +2455 4 11.3539 23.0451 18.66 8.78619 -1.44678 0.615593 +2456 4 10.601 22.3432 17.4702 -0.435219 15.7289 22.4338 +2457 6 35.9047 14.2516 40.1476 -11.9566 8.08227 -8.12446 +2458 4 35.3828 14.5983 39.4171 17.9635 11.5828 -3.36223 +2459 4 35.2535 13.6726 40.504 -8.36759 -16.975 21.7169 +2460 6 6.70775 1.0715 17.7189 7.50642 -21.2746 -7.36561 +2461 4 6.22784 1.34485 18.5084 1.44497 -10.5234 3.95628 +2462 4 6.91772 0.0894674 17.7256 -13.4419 30.1572 13.7277 +2463 6 41.3365 34.0623 33.1636 23.1157 -5.84267 13.8333 +2464 4 40.4227 34.234 32.9444 -15.3258 11.3352 -14.6542 +2465 4 41.9184 34.5849 32.5841 -12.4833 3.91505 -3.84565 +2466 6 37.2858 0.99342 41.2878 7.36827 13.3221 -16.8172 +2467 4 37.4859 0.112276 40.9658 -1.88555 -12.2628 0.361589 +2468 4 37.4834 1.0172 0.312287 5.29267 -3.40266 15.6364 +2469 6 25.2541 30.9749 6.2071 -22.7336 2.5299 17.3506 +2470 4 26.0217 31.2424 5.69829 1.89843 -3.96463 -15.2281 +2471 4 24.4182 30.8551 5.69564 23.045 5.74277 3.20871 +2472 6 14.1871 24.4929 28.313 -6.35756 40.4048 -1.58139 +2473 4 14.3311 23.6816 28.7714 -3.10946 -31.1704 -0.0360927 +2474 4 13.792 24.4319 27.4273 2.40698 -14.1025 6.50138 +2475 6 34.2078 26.2332 36.0169 -41.3887 31.6455 20.302 +2476 4 35.1375 26.2713 36.1926 18.3831 1.21525 6.50399 +2477 4 33.7458 26.9646 36.5669 26.0782 -29.6148 -21.0343 +2478 6 32.3696 8.32545 27.9988 -31.7689 14.924 14.5852 +2479 4 32.5206 9.30939 28.0669 10.5891 -30.1429 -9.37737 +2480 4 33.1235 7.86931 27.6333 20.3768 10.5357 -6.59273 +2481 6 11.7881 0.276326 26.9686 -1.26514 -24.1343 -2.09554 +2482 4 11.7898 41.2288 26.6922 -1.19404 21.3361 9.01519 +2483 4 11.5977 0.31005 27.9205 2.09711 -1.6438 -10.9729 +2484 6 1.68282 0.256654 10.3371 7.78574 -7.1909 -12.7427 +2485 4 1.59984 41.2742 10.69 -0.913761 -2.35777 -0.20094 +2486 4 1.41183 0.821253 11.0453 -5.61238 10.3042 16.839 +2487 6 6.75659 13.8554 8.24275 2.15336 8.75665 -12.4729 +2488 4 6.4538 13.9004 7.29654 11.603 6.79512 25.9161 +2489 4 7.29723 14.6482 8.44053 -3.39366 -6.31817 -8.96948 +2490 6 22.229 20.5516 6.16712 -19.4021 -6.23502 11.2792 +2491 4 21.7175 21.3783 6.29668 6.22315 -10.0472 -0.391558 +2492 4 21.7004 19.8262 6.58709 9.33903 15.1246 -7.94106 +2493 6 17.3809 20.4508 10.8712 -6.33142 3.08518 -4.04876 +2494 4 16.5461 20.08 10.4568 21.8919 23.129 5.85777 +2495 4 17.5363 21.4129 10.6625 -13.97 -26.3983 1.7074 +2496 6 17.7006 4.52466 19.5892 5.66371 -4.97651 -9.86024 +2497 4 16.9376 4.52739 20.1892 -4.06273 -5.34645 -7.80596 +2498 4 17.5412 3.84457 18.8839 -0.885651 16.9891 23.3258 +2499 6 0.475545 18.1168 40.0844 5.30586 -7.45209 -16.0452 +2500 4 0.255658 18.7395 40.7612 -0.602959 14.3131 10.4938 +2501 4 1.33302 18.3868 39.7002 -7.70736 -6.31105 3.74686 +2502 6 22.9439 24.8338 27.8349 -3.23408 23.09 -51.7359 +2503 4 22.7283 25.5292 27.1178 5.97449 -27.0764 31.3639 +2504 4 22.8278 25.2464 28.677 -4.11703 14.8593 21.0934 +2505 6 42.7959 39.1553 26.7627 -13.6288 14.9904 24.3142 +2506 4 42.9559 38.4383 26.1586 10.7263 -7.78522 -15.113 +2507 4 43.351 39.9224 26.5692 3.77188 -7.24305 -5.18193 +2508 6 26.2354 3.05796 21.7982 1.74018 25.1467 -10.7915 +2509 4 25.6923 3.78105 22.1642 10.9011 -13.8467 -3.1836 +2510 4 26.7888 3.50003 21.1142 -10.0122 -11.5362 10.4851 +2511 6 54.6007 9.88011 29.5829 2.61324 -0.835643 16.9334 +2512 4 53.983 9.1383 29.6239 1.49377 0.577448 -2.59463 +2513 4 54.746 10.0983 30.5296 -2.21833 -1.79811 -18.9561 +2514 6 24.7578 33.7363 20.5387 -17.5006 5.04967 -0.0763559 +2515 4 24.6934 34.6555 20.8512 7.60819 -4.12262 3.6003 +2516 4 23.9235 33.6132 20.0554 5.3121 -3.42637 -1.44671 +2517 6 41.6963 16.3109 0.897802 2.88421 10.066 -28.0255 +2518 4 41.3077 16.0362 1.70176 -16.3219 -5.78099 30.2108 +2519 4 42.6299 16.1901 1.06805 12.6035 -3.11322 -2.97519 +2520 6 23.404 27.9303 27.4821 -1.06023 20.2241 -21.3645 +2521 4 22.8141 28.2554 28.1835 2.551 -1.87769 -8.73241 +2522 4 23.2629 28.4828 26.6516 2.17993 -16.4871 31.3925 +2523 6 32.7813 37.2936 18.7328 38.5641 -14.7697 6.75932 +2524 4 33.752 37.1016 18.9061 -34.9795 -0.437252 0.892363 +2525 4 32.8311 38.1729 18.3762 -6.70298 14.6722 -8.07554 +2526 6 21.2305 27.6771 4.7955 -18.4608 -25.795 -24.9287 +2527 4 20.5062 27.4644 5.39651 2.92048 5.31567 1.45057 +2528 4 20.941 27.2184 3.94502 12.5509 18.4099 23.8236 +2529 6 54.9409 17.9571 1.83459 -7.07205 6.42915 6.55936 +2530 4 54.7029 17.1381 1.42965 7.06691 -21.815 -7.49321 +2531 4 54.119 18.4405 1.74821 -9.38537 8.8513 -0.363257 +2532 6 36.7335 10.6984 6.58912 -34.5362 -0.324761 -4.53473 +2533 4 35.7609 10.9799 6.6143 34.1258 -12.1011 2.72213 +2534 4 36.7696 9.77633 6.90859 -3.13742 6.31851 -1.30765 +2535 6 54.2706 4.50024 14.0257 -11.269 5.99606 -15.4247 +2536 4 53.8536 5.11876 13.3604 4.87759 -11.992 26.1673 +2537 4 53.895 4.59469 14.9192 -3.76531 8.72829 -7.53187 +2538 6 22.107 12.8255 32.0148 27.0088 -6.82073 4.3703 +2539 4 21.2061 13.1328 31.8952 -10.7145 6.62508 -9.34344 +2540 4 22.7298 13.2576 31.3917 -17.4011 -3.99159 8.00208 +2541 6 15.2931 36.6619 4.04206 -24.4039 12.3238 20.1693 +2542 4 15.3606 37.6342 3.9855 6.08423 -9.62309 -2.22716 +2543 4 16.0243 36.2999 3.55051 12.1414 -1.28609 -8.9598 +2544 6 23.9518 1.27347 5.70825 1.82336 16.8815 15.3992 +2545 4 23.158 0.731739 5.71694 -5.31944 -7.03749 -3.2154 +2546 4 23.9846 1.73289 6.57368 -1.26671 -8.46254 -14.2674 +2547 6 14.3069 12.6571 15.8074 -11.3886 -13.8779 -22.9988 +2548 4 14.4908 12.4438 14.8835 17.1875 4.58775 1.43504 +2549 4 13.3991 12.3171 15.8566 5.60683 8.95198 18.2444 +2550 6 15.0463 40.2277 6.58272 -14.4539 15.1029 5.15073 +2551 4 15.8086 40.489 7.08192 22.3652 -6.01515 7.9389 +2552 4 14.4962 41.022 6.75392 -6.77819 -16.9793 -13.6053 +2553 6 48.5629 32.6194 12.091 2.37027 -5.84764 -3.4739 +2554 4 48.1048 31.8776 11.6348 7.57669 12.4587 1.43975 +2555 4 49.3373 32.9111 11.5511 -18.0393 -12.2542 5.39731 +2556 6 11.2883 31.5349 7.21941 -5.75599 -10.1169 -16.3625 +2557 4 10.675 30.8987 6.79271 12.7122 10.5617 8.56414 +2558 4 11.681 32.0415 6.48473 -4.52974 -6.63428 7.17241 +2559 6 30.1204 27.9925 10.216 2.65146 5.67665 0.571004 +2560 4 30.7332 28.7325 10.019 -7.63861 -11.6097 -0.594568 +2561 4 29.9063 27.5181 9.39417 2.857 4.22172 -1.33476 +2562 6 27.6817 22.1076 17.3717 2.13561 -8.21554 7.46684 +2563 4 27.3138 21.4721 16.7296 5.88092 9.15558 -3.1228 +2564 4 28.0594 22.8778 16.9197 -3.27829 -5.84867 -5.86393 +2565 6 12.9588 4.5965 18.1625 2.45174 -26.8216 -12.137 +2566 4 13.4346 3.75914 18.3684 -5.38503 16.4797 0.486183 +2567 4 12.5704 4.4145 17.2814 1.35975 11.1796 8.84538 +2568 6 19.7171 6.72206 19.0824 18.7149 18.1076 8.78634 +2569 4 19.0276 6.07043 19.1643 -12.8479 -14.7766 2.48779 +2570 4 20.149 6.78349 19.9504 -8.03044 -1.70313 -8.42964 +2571 6 37.158 31.386 11.4948 13.5333 -6.17925 -0.534196 +2572 4 36.3748 31.5241 12.0574 10.6691 -10.2998 8.4252 +2573 4 37.8298 30.7884 11.9154 -26.2348 9.80485 0.777976 +2574 6 3.12167 16.2038 27.3537 -19.2499 -26.3416 -14.9115 +2575 4 2.564 15.4232 27.613 17.9651 21.4634 -3.17821 +2576 4 3.05771 16.2343 26.3741 -0.0558506 5.44355 20.7735 +2577 6 15.7152 9.97508 38.3617 37.2659 20.4939 22.6587 +2578 4 16.1689 10.8384 38.1525 -17.0523 -25.976 5.55091 +2579 4 16.2475 9.64647 39.1327 -18.0975 2.21635 -20.7757 +2580 6 13.3945 14.2914 8.22355 52.7406 24.0557 20.8129 +2581 4 13.9343 15.0997 8.53617 -32.8018 -27.7376 -11.9171 +2582 4 14.0669 13.5802 8.35008 -24.0553 1.67412 -6.96019 +2583 6 1.72299 24.3133 36.3936 32.5837 -28.3335 21.1288 +2584 4 1.96116 25.1215 36.8464 -1.44419 12.4956 -1.11134 +2585 4 1.10799 24.5417 35.7277 -24.491 15.1488 -24.3141 +2586 6 11.1925 26.5189 32.9725 1.88857 3.23229 20.5962 +2587 4 10.9062 26.8258 32.1286 -6.138 -2.28585 -27.1412 +2588 4 11.0637 27.2989 33.5293 3.02186 -7.15206 7.83107 +2589 6 29.5898 0.769141 36.29 0.770047 10.6645 18.3277 +2590 4 29.1085 0.54227 35.5145 -3.81283 -13.529 -27.0487 +2591 4 28.8904 1.11515 36.8518 6.86702 4.29265 4.12775 +2592 6 43.6054 13.1224 23.9122 -2.46968 6.93561 -17.1322 +2593 4 42.8447 13.3401 24.4619 -4.47847 1.10283 0.728731 +2594 4 43.3126 13.2067 22.9653 4.50753 -0.208477 27.3689 +2595 6 7.45217 19.7807 19.6677 5.33955 -1.6221 -12.877 +2596 4 6.80427 19.1226 19.9251 -3.45906 -4.13396 8.35684 +2597 4 7.46466 19.745 18.7046 0.226191 5.91599 3.73904 +2598 6 24.4186 4.28854 7.83154 -9.27237 -3.93777 -5.86373 +2599 4 24.1141 5.19611 7.95791 2.72117 -5.11917 -0.666563 +2600 4 25.0574 4.07609 8.5187 1.73531 2.38301 -0.0162684 +2601 6 51.4783 30.2365 31.1578 4.43663 8.1051 17.8753 +2602 4 50.5719 29.9409 31.3316 -1.01079 -0.531629 -9.26743 +2603 4 51.6665 30.2531 30.2149 -6.58635 -1.64064 -12.0931 +2604 6 0.928618 23.6677 16.8891 39.1558 -2.20072 16.2176 +2605 4 0.0728448 23.4362 16.5368 -6.93512 -13.3273 -6.91209 +2606 4 1.45563 22.867 17.1505 -20.9828 13.2836 -9.64814 +2607 6 45.0876 19.3948 15.692 7.86589 27.8079 -34.4593 +2608 4 45.9117 18.9264 15.546 6.38244 -8.87865 2.87525 +2609 4 44.6429 18.9609 16.3882 -19.7965 -22.2098 30.8606 +2610 6 17.4975 8.71947 40.5884 -15.3884 33.6574 -8.04213 +2611 4 18.1832 9.38307 40.741 -0.0730079 1.31818 -0.306908 +2612 4 17.9142 7.90906 40.8182 15.4372 -26.466 6.58932 +2613 6 30.1853 27.2566 27.195 -12.9952 17.3445 1.1523 +2614 4 31.1231 27.467 27.0889 -0.851996 0.391463 0.93648 +2615 4 29.6983 28.1205 27.2412 18.1484 -22.709 -4.59112 +2616 6 43.0643 26.2027 28.3545 -5.31946 22.0639 -20.7107 +2617 4 43.281 25.753 27.5201 1.76973 -3.45008 6.18356 +2618 4 43.0898 25.5645 29.0616 2.35339 -12.574 6.70826 +2619 6 27.9963 7.58777 3.05558 10.5798 9.34284 19.8534 +2620 4 28.0446 6.83168 2.47717 -2.58104 -14.3156 -10.0889 +2621 4 28.509 7.35692 3.86128 -6.64638 2.01122 -8.68086 +2622 6 44.6822 7.22369 10.1895 -15.4824 21.4485 13.7445 +2623 4 44.4465 7.45383 11.1264 7.27839 -9.51736 -18.1425 +2624 4 45.2115 6.42757 10.2073 4.94307 -7.89984 8.76143 +2625 6 23.5336 20.3897 32.2571 -4.86538 -1.36788 -16.1605 +2626 4 23.3032 21.2113 32.7104 1.28111 0.523216 5.34569 +2627 4 23.9774 19.8232 32.8948 2.81274 0.218846 6.19737 +2628 6 37.5478 21.0473 29.278 -18.5062 7.79735 6.57819 +2629 4 37.2371 20.358 28.6908 4.72073 -14.165 -12.1471 +2630 4 36.7158 21.4163 29.628 13.2175 4.90017 2.66375 +2631 6 49.286 29.0703 28.699 10.8186 8.22027 -9.31733 +2632 4 48.7028 29.7991 28.456 -10.3299 -0.414367 -0.610456 +2633 4 50.1517 29.4276 28.433 0.637469 -9.81751 4.99071 +2634 6 47.52 18.1671 15.2208 -2.7229 30.7912 -34.1138 +2635 4 48.0078 17.7317 15.8928 12.2019 -13.0526 25.5862 +2636 4 48.0044 19.0008 15.0204 -10.6208 -16.322 3.06818 +2637 6 23.2448 11.1727 16.5931 -14.8157 -11.6244 -0.308602 +2638 4 23.8342 11.8286 16.2582 11.4387 21.3683 -6.30591 +2639 4 23.6559 10.3501 16.3116 -3.14365 -5.23997 2.15847 +2640 6 3.13911 8.33446 23.1963 -2.69702 8.14317 3.16076 +2641 4 3.4034 7.82956 22.4196 3.11719 -1.75335 -2.44085 +2642 4 3.61355 9.18537 23.1574 -2.855 -3.87959 1.25156 +2643 6 0.502965 16.1866 6.18545 3.06312 3.24934 37.7622 +2644 4 1.47856 16.2897 6.04903 -24.0003 -4.70784 4.68468 +2645 4 0.309706 16.1237 7.18858 13.4295 2.89967 -42.1744 +2646 6 43.1771 15.7066 5.83749 -5.07319 -7.51407 -5.60477 +2647 4 43.0136 16.4204 6.43488 -7.5966 11.2789 14.4199 +2648 4 44.0623 15.8898 5.5251 15.5631 0.134699 -7.60204 +2649 6 16.7019 35.4798 34.4572 -11.2013 7.16284 28.6023 +2650 4 15.9782 34.9492 34.0738 5.35466 1.61493 8.45244 +2651 4 16.3895 35.7941 35.362 6.52255 -9.83405 -29.4813 +2652 6 38.8822 7.74245 15.6771 24.467 26.2162 11.5837 +2653 4 39.1941 7.06316 15.0707 0.325231 -3.95447 -5.25413 +2654 4 39.6937 8.2709 15.9758 -30.2905 -22.5291 -12.0432 +2655 6 42.0043 36.5204 13.6369 3.57579 19.2035 0.0265624 +2656 4 41.9371 35.5667 13.6578 -6.58441 -9.91584 1.38486 +2657 4 41.1548 36.8737 13.3269 0.670997 -7.61264 0.497391 +2658 6 54.2965 15.3698 32.1203 7.94984 -1.57724 11.6593 +2659 4 0.00278476 15.9714 32.4364 -1.97539 -6.90512 -0.0853595 +2660 4 53.6257 15.9484 31.7567 -4.83125 0.736868 -4.95397 +2661 6 22.8953 13.994 39.0277 29.317 0.766946 3.70607 +2662 4 23.2673 14.8115 39.3939 -3.87119 -6.48985 -1.20924 +2663 4 21.9724 14.1463 38.894 -27.0425 2.87882 -4.26486 +2664 6 48.0413 28.5291 4.79053 -11.6037 -2.58599 22.6989 +2665 4 48.6027 28.7991 4.07655 16.555 3.34212 -19.6439 +2666 4 47.7045 29.3636 5.15455 0.064426 -0.719185 3.47056 +2667 6 48.8324 10.6079 2.66689 -4.06073 -3.45613 -38.269 +2668 4 48.225 10.1372 3.21562 -13.339 -11.2438 14.6703 +2669 4 49.3888 11.1314 3.20945 16.7197 17.33 23.918 +2670 6 17.1017 29.3417 4.42129 -6.1746 1.2215 19.6287 +2671 4 16.2515 28.9749 4.73431 4.06151 0.983408 -5.41825 +2672 4 17.5169 29.7258 5.22535 1.37581 -6.66399 -13.2687 +2673 6 27.7925 7.31966 26.5665 39.3465 35.5797 -5.30427 +2674 4 28.7629 7.09708 26.703 -34.5848 -6.71948 -0.628584 +2675 4 27.2286 6.57009 26.6643 -1.86949 -31.2701 4.24572 +2676 6 18.0221 22.0409 22.5172 -16.5701 10.2349 -21.3339 +2677 4 18.5639 21.2383 22.5163 -1.8186 -3.43948 -8.36361 +2678 4 17.5144 22.1102 21.6408 22.068 -10.0871 32.2991 +2679 6 22.1395 25.0891 16.7042 -20.9036 23.9116 7.05274 +2680 4 21.7854 25.6501 15.9625 11.5166 -19.4533 18.3362 +2681 4 22.5191 24.3092 16.3181 5.92374 -8.20656 -11.3677 +2682 6 25.488 28.4523 7.12785 -10.8823 -15.9396 20.8595 +2683 4 25.4981 28.5494 8.12476 3.48758 8.16016 -33.1398 +2684 4 25.5521 29.3092 6.69674 -1.4246 11.8198 7.49476 +2685 6 42.5416 24.7341 23.7389 -17.4504 20.5814 2.46415 +2686 4 41.7374 25.1978 24.1118 21.637 -12.0739 -8.95046 +2687 4 42.3838 23.7928 23.8344 -7.43983 -12.597 1.84916 +2688 6 6.22002 16.6178 2.47863 15.1987 22.5956 5.3052 +2689 4 5.33799 17.0017 2.41879 -13.1624 -14.3434 -0.0608379 +2690 4 6.24934 15.6649 2.55192 -10.5885 -12.312 -0.729605 +2691 6 47.3735 33.281 1.45237 -1.26376 -9.34891 -34.4477 +2692 4 47.004 34.1558 1.53803 -0.151384 8.42018 6.19826 +2693 4 47.7374 33.0316 2.29181 5.29029 2.56444 17.845 +2694 6 1.28124 36.1882 24.8833 15.6174 10.404 -23.7919 +2695 4 0.591937 36.4933 25.4703 -7.67557 -4.15788 11.0948 +2696 4 1.63511 35.375 25.2549 -3.92235 -3.89482 10.8998 +2697 6 20.9296 29.0485 16.4244 -14.8946 8.72798 0.140185 +2698 4 21.4494 28.4837 15.8729 6.14594 -21.5718 -11.6475 +2699 4 21.5122 29.7657 16.643 5.64358 11.2813 6.66084 +2700 6 18.6504 32.5428 14.1464 30.5599 1.70581 -2.73789 +2701 4 17.8579 33.056 14.2705 -20.3424 -4.20043 8.80032 +2702 4 18.5989 31.5954 14.3835 -16.0449 10.8642 1.76069 +2703 6 15.729 41.6925 0.00385817 -5.28292 -15.868 -0.0471225 +2704 4 15.6317 41.084 41.1283 -1.722 11.921 23.9575 +2705 4 15.1873 41.3899 0.782005 8.67232 1.52126 -23.9336 +2706 6 20.5292 18.4098 7.21323 -2.91221 4.89049 5.17577 +2707 4 20.2914 18.5583 8.16487 -5.028 -0.721877 -18.2737 +2708 4 19.7413 18.3526 6.62958 8.30767 0.291632 18.8261 +2709 6 35.3342 2.82915 1.61883 3.51298 26.3767 19.1091 +2710 4 35.0331 3.19583 2.50754 16.3791 -7.36031 -35.2043 +2711 4 35.9206 3.53855 1.22039 -16.4006 -18.5858 14.5973 +2712 6 48.9922 19.6721 24.94 -34.075 0.0390245 -1.22883 +2713 4 49.8199 19.2352 24.7823 16.5976 -0.114011 -0.96393 +2714 4 49.1617 20.6125 25.0649 5.94448 -3.86752 4.03728 +2715 6 26.0294 7.18427 41.5679 18.6543 -22.0446 -14.9111 +2716 4 26.7755 6.56315 41.735 -11.6555 11.6244 -4.08136 +2717 4 25.6575 7.3193 0.515359 -11.3234 5.2253 22.1616 +2718 6 22.0232 3.61039 29.0191 -5.74486 -2.38085 -7.46091 +2719 4 21.2539 3.82496 28.4513 11.98 3.27859 6.66273 +2720 4 22.2148 4.35673 29.5966 -4.60401 3.08527 0.791206 +2721 6 27.8512 32.5337 20.6565 16.709 -10.0789 14.6393 +2722 4 26.9625 32.7469 20.4552 -34.4793 1.21347 -3.16249 +2723 4 28.3469 33.1233 20.1026 12.1012 5.18966 -5.24336 +2724 6 8.41229 24.7869 3.46082 22.3386 15.1563 9.53263 +2725 4 8.90357 24.2552 2.84068 9.55631 -8.44952 -10.853 +2726 4 7.60423 24.3318 3.61908 -22.8615 -12.1417 2.22131 +2727 6 30.5897 41.7312 15.6484 22.6974 7.2585 28.5546 +2728 4 29.9644 0.0840213 16.3484 1.9076 -3.76769 -8.41354 +2729 4 30.1014 41.5664 14.8669 -20.7398 -7.21626 -25.2002 +2730 6 48.088 5.62638 21.1953 6.60529 -8.20232 0.106871 +2731 4 47.6746 6.34733 20.7055 -8.23977 -5.05625 1.96425 +2732 4 47.4017 5.06013 21.5879 -0.150274 10.975 -6.21391 +2733 6 39.4216 23.1741 35.7526 -24.6601 -13.9913 -21.1364 +2734 4 39.9113 23.6202 36.3986 28.8985 24.9348 33.8823 +2735 4 38.8958 22.5444 36.2533 -4.57276 -5.65639 2.90172 +2736 6 51.5794 33.3637 5.78804 -15.2387 -43.0642 -16.4958 +2737 4 51.7543 34.264 5.94613 8.32006 43.2545 8.99501 +2738 4 51.5314 33.243 4.82206 1.27667 3.09716 8.04215 +2739 6 40.1245 17.6149 30.7901 8.56984 -3.86721 -1.09973 +2740 4 39.7659 18.4612 31.0527 -2.58034 0.199434 5.42908 +2741 4 40.7245 17.8709 30.0792 -0.880063 -10.8459 -3.09375 +2742 6 46.409 9.80599 18.5787 -10.6525 10.5445 16.3312 +2743 4 47.1858 10.3579 18.4839 1.73901 1.20814 1.97642 +2744 4 46.4156 9.2339 17.8265 -1.18405 -17.3223 -19.0152 +2745 6 15.8964 41.084 31.9275 -7.67529 -16.3413 6.36199 +2746 4 16.5726 40.6297 31.3851 0.744388 15.1086 2.48527 +2747 4 16.0838 0.121849 31.9545 10.6182 0.477469 -6.79561 +2748 6 48.5579 25.7373 14.9245 -32.9201 0.62376 14.4593 +2749 4 49.4842 25.8337 14.7718 19.5896 2.21134 -17.0603 +2750 4 48.049 25.8802 14.1037 15.4245 2.93063 1.46628 +2751 6 39.2312 28.9787 36.1455 -14.672 -4.00104 3.01304 +2752 4 39.9934 29.3216 36.628 6.25522 6.25199 -7.03146 +2753 4 39.4638 28.7366 35.2366 10.4577 0.0924929 -3.6403 +2754 6 37.3289 21.0516 14.9314 -10.8689 -7.09111 1.49701 +2755 4 38.071 20.892 14.3011 -28.0288 10.0477 -1.14031 +2756 4 36.4673 21.3942 14.5393 36.2132 -8.93414 7.14583 +2757 6 32.4934 22.8531 15.7417 3.10645 -11.4389 20.7178 +2758 4 31.7266 22.539 15.2235 4.17967 -1.79737 6.20971 +2759 4 32.6084 22.2825 16.5528 -7.19864 12.5613 -26.7488 +2760 6 18.5678 8.15053 37.5885 12.1963 17.253 1.38788 +2761 4 19.2402 8.85275 37.7813 -15.6951 -12.294 2.78452 +2762 4 17.9606 8.11124 38.3342 2.60008 5.05619 4.87993 +2763 6 46.9436 30.3797 11.0104 1.88703 -1.83756 -2.66296 +2764 4 46.4577 30.6986 10.2121 16.8565 -15.5671 12.8865 +2765 4 47.4104 29.5424 10.7815 -11.8828 15.01 -3.66074 +2766 6 54.6316 13.0448 30.6676 -4.47091 -6.8042 2.85617 +2767 4 54.8929 12.2323 31.1402 -1.2342 7.60269 0.15722 +2768 4 54.6603 13.771 31.309 -0.297949 0.849652 -1.52079 +2769 6 32.2951 35.1224 27.9786 -1.77947 21.9995 15.3623 +2770 4 32.2792 35.8643 28.662 -2.01418 -27.5067 -15.3374 +2771 4 32.1621 34.2527 28.3767 0.559318 -0.0892981 14.8897 +2772 6 4.45055 25.4036 31.7899 -1.02142 -16.2715 16.4968 +2773 4 4.99753 24.9958 32.4777 -6.33224 -6.47315 3.67169 +2774 4 4.91071 26.2154 31.6821 9.55032 31.2277 -12.9728 +2775 6 40.7771 38.1434 21.8579 6.80518 1.6634 -4.63259 +2776 4 40.7449 39.0581 22.1203 -10.5616 15.8809 15.9679 +2777 4 41.4448 38.2055 21.1733 6.63637 -13.627 -11.1518 +2778 6 26.6799 9.85647 27.3982 -25.6987 30.8747 18.2417 +2779 4 27.0738 9.12687 26.9584 7.64189 -30.2216 -11.3166 +2780 4 25.7862 9.62595 27.7363 13.5029 -2.01996 -6.34848 +2781 6 53.4177 39.431 11.7682 60.4327 6.90374 -14.3662 +2782 4 54.4363 39.4906 11.5459 -51.7213 -2.15349 13.0324 +2783 4 53.0514 40.2823 11.4531 3.65586 -10.6921 6.91198 +2784 6 35.3318 21.4177 2.24537 5.41769 -12.1321 -20.1082 +2785 4 34.8431 20.6225 2.51379 1.47903 7.83344 1.83382 +2786 4 35.7036 21.1864 1.3528 -11.9529 6.47568 24.5243 +2787 6 4.13637 17.136 33.9211 3.37621 -12.3766 5.67686 +2788 4 4.20441 16.396 34.5697 -7.88327 11.3141 -11.775 +2789 4 3.23668 17.1493 33.5445 4.32036 -6.23827 5.33579 +2790 6 24.1551 16.173 14.6595 0.905264 -13.203 -15.7913 +2791 4 24.2344 17.0724 14.9677 3.21898 8.1818 3.14137 +2792 4 23.7074 16.2777 13.8038 1.81958 -4.41422 2.08172 +2793 6 43.135 2.84466 26.1032 13.1229 6.35408 -5.68313 +2794 4 42.2875 3.17639 26.414 -4.49653 4.08553 -4.30298 +2795 4 43.2684 3.17059 25.1875 -5.24638 -3.17663 12.7173 +2796 6 40.6938 12.184 1.56501 -11.5288 -7.07153 -25.6549 +2797 4 41.6237 12.1687 1.8186 -0.151998 5.09311 17.9246 +2798 4 40.0653 12.4844 2.24465 11.7671 0.703669 4.7582 +2799 6 47.3771 8.09383 26.755 61.1653 27.2124 16.0462 +2800 4 46.6352 7.69428 26.3774 -33.8593 -24.2939 -29.8281 +2801 4 48.1554 8.02079 26.1437 -24.5213 -4.41693 14.2109 +2802 6 35.8722 30.7298 38.4929 46.7797 8.20249 -0.795626 +2803 4 35.8437 29.9971 39.0885 -23.8052 -20.0767 8.1402 +2804 4 36.8495 30.8926 38.5637 -31.083 11.8011 -18.5205 +2805 6 51.2951 23.2205 32.4921 -21.4102 17.5258 -2.96787 +2806 4 51.6315 24.0445 32.1105 -0.705735 5.94923 -0.836877 +2807 4 52.0737 22.714 32.6486 16.7198 -16.4886 4.04233 +2808 6 30.6141 4.4461 39.6711 -15.3731 3.79473 -35.0115 +2809 4 30.9464 3.61986 40.0176 9.77962 -4.83986 19.2734 +2810 4 30.7704 5.18568 40.2576 9.11216 5.26318 14.244 +2811 6 35.2646 29.7051 2.85778 -14.8887 -12.395 -20.7058 +2812 4 35.7986 29.7272 2.02588 -11.2321 -1.99949 14.2373 +2813 4 34.4405 29.1492 2.64359 32.9241 21.0754 6.44042 +2814 6 50.3111 26.1454 9.40098 -22.1621 10.9454 -20.0185 +2815 4 49.986 26.7793 8.71172 15.2241 -16.6208 13.1315 +2816 4 49.7063 25.388 9.31525 11.793 4.08785 3.97386 +2817 6 50.0869 36.8245 26.4088 -20.9012 -6.38176 7.71076 +2818 4 49.5586 36.0705 26.7514 3.9746 5.79943 -8.74909 +2819 4 50.1941 37.3864 27.1871 4.41306 8.36789 0.548966 +2820 6 40.3119 23.9565 38.5384 47.4279 -1.39254 -15.5521 +2821 4 40.88 24.732 38.748 -21.3925 -13.0784 -2.40019 +2822 4 39.4343 24.1145 38.8527 -20.1214 13.5622 11.7594 +2823 6 24.9444 10.7496 30.6663 31.051 18.5451 27.0394 +2824 4 25.7305 10.8456 31.2787 -28.4 -7.1047 -26.2292 +2825 4 24.8995 11.6269 30.2371 -7.15612 -14.1049 -2.61146 +2826 6 5.89131 1.01728 5.39947 -5.16247 -17.9253 -0.227043 +2827 4 5.22088 0.340863 5.59281 2.49468 7.88844 1.50452 +2828 4 6.71299 0.544267 5.57411 4.99832 4.76302 -4.28882 +2829 6 44.2927 29.3807 26.2764 43.728 -18.4205 -0.18667 +2830 4 43.5018 29.5461 25.816 -39.4067 7.83222 -12.62 +2831 4 44.7851 28.7616 25.699 -3.50466 6.32584 16.51 +2832 6 25.3064 10.1814 6.6654 -6.94402 -15.718 -9.61204 +2833 4 25.6542 11.0594 6.61048 6.10034 18.8978 1.37462 +2834 4 25.5624 9.77067 5.8255 0.943829 -2.29537 1.40094 +2835 6 13.3606 28.0664 2.58456 21.0736 -2.27515 1.79417 +2836 4 12.4645 27.8304 2.42125 -25.9451 -0.745297 2.44011 +2837 4 13.7867 27.7237 1.79619 10.8353 3.06046 3.23802 +2838 6 6.45257 40.24 18.0133 20.0379 8.33657 1.98834 +2839 4 6.89988 39.3931 17.8777 -5.14522 -3.62214 0.392952 +2840 4 5.56311 40.1207 17.6969 -15.0406 -3.82351 -6.06839 +2841 6 47.8011 13.5056 2.01844 -10.5648 -21.267 23.3214 +2842 4 48.1524 12.6081 2.17165 -2.87721 6.43796 -2.24674 +2843 4 48.4275 13.9546 1.48105 20.9852 11.6376 -18.273 +2844 6 13.5939 20.3067 2.43603 17.8956 14.689 14.157 +2845 4 13.8339 19.6256 3.09172 -4.40777 3.66463 -6.9739 +2846 4 12.9598 19.9059 1.86118 -14.8369 -10.3601 -11.305 +2847 6 15.2334 0.8368 36.6591 1.55142 7.70692 -22.3998 +2848 4 15.2542 1.38367 37.4773 0.960764 -3.32816 -20.1037 +2849 4 15.3344 1.45306 35.8608 -4.23652 -17.7771 37.8382 +2850 6 33.6147 35.2459 15.1 16.7734 -11.8793 -18.4599 +2851 4 33.8163 35.2873 16.0538 13.2499 -3.34836 -12.9991 +2852 4 34.4154 34.9808 14.5294 -23.6504 9.8312 34.8639 +2853 6 21.8005 9.23588 0.431159 13.8262 -19.7524 30.0596 +2854 4 22.4067 9.05801 41.6249 5.27322 -0.932182 -12.5411 +2855 4 21.1072 9.74412 0.0564903 -22.836 18.1195 -16.0408 +2856 6 38.1565 27.4627 3.04439 18.4183 -28.2807 7.84104 +2857 4 37.7322 27.3164 2.21113 -4.60599 -14.2952 -24.3043 +2858 4 37.7632 28.2451 3.34335 -13.6136 36.2365 19.5187 +2859 6 38.8873 27.196 11.7739 15.5044 -8.33717 -5.93911 +2860 4 38.7841 26.3327 12.232 6.37868 6.61944 -11.5261 +2861 4 39.5786 27.1133 11.0659 -17.5863 -8.28826 19.2684 +2862 6 29.8757 41.5959 28.7066 13.5858 28.49 -11.3766 +2863 4 28.9647 41.3014 28.7466 -9.40406 -2.02578 1.88502 +2864 4 29.8997 0.254331 27.9025 -2.68961 -11.7418 13.302 +2865 6 34.0266 8.72323 38.0698 33.719 9.40995 4.6971 +2866 4 34.8877 8.24089 38.094 -11.378 13.1352 -1.62724 +2867 4 33.3712 8.08689 37.8245 -20.4874 -15.945 -8.86187 +2868 6 38.8142 27.3472 30.6886 -7.48306 -22.0573 -0.58069 +2869 4 38.4096 26.5151 30.3537 9.19692 16.3236 1.53567 +2870 4 38.2655 27.5885 31.4334 -4.0026 6.56393 5.14207 +2871 6 41.6513 17.2644 36.3568 8.49285 18.5772 4.12306 +2872 4 41.236 17.1887 35.5016 -7.55839 -3.54967 -10.3568 +2873 4 41.7813 16.3888 36.7033 1.22956 -17.0266 1.65102 +2874 6 30.7157 26.9788 35.2038 -10.151 -4.28381 0.0670681 +2875 4 31.4488 27.4236 34.7965 20.0965 0.384289 -13.2747 +2876 4 30.343 27.6484 35.7639 -8.80839 6.96039 12.3672 +2877 6 47.5342 4.10778 27.2888 11.6095 8.93875 26.3727 +2878 4 46.6105 4.27591 27.501 -8.38331 -0.425724 -4.8003 +2879 4 47.5988 3.99389 26.3497 -6.2541 -0.220522 -17.1995 +2880 6 20.9412 8.38521 7.26575 -18.1268 -17.2637 2.68033 +2881 4 20.8809 8.87169 8.08328 -6.592 1.96128 21.9757 +2882 4 21.4179 8.98778 6.73029 19.5174 18.1449 -30.7672 +2883 6 36.8608 13.6781 0.872276 -22.567 18.0135 -7.8322 +2884 4 37.3857 13.5342 1.64823 18.2236 -14.2068 17.6988 +2885 4 36.9649 12.9376 0.269125 7.56106 -9.0363 2.17502 +2886 6 28.5805 20.3012 26.4498 13.4935 0.222411 -13.7489 +2887 4 28.4835 19.3803 26.2016 0.90122 -3.21423 2.30104 +2888 4 27.7964 20.5416 26.9224 -18.5183 5.12398 12.3317 +2889 6 51.6021 16.8515 33.5179 -11.2544 -15.3 0.627003 +2890 4 51.563 16.0241 34.0301 0.916298 4.09207 -0.753195 +2891 4 51.0058 16.6639 32.7753 6.31462 4.20327 -0.345536 +2892 6 16.2626 32.019 37.6812 -31.2107 -29.2496 -22.9287 +2893 4 16.4537 31.3803 38.4011 -2.23747 12.829 -12.3594 +2894 4 15.5373 31.5705 37.1079 31.9743 21.1891 23.5065 +2895 6 14.3366 25.8859 13.2055 -16.2598 35.1345 -7.65407 +2896 4 13.5591 26.1022 13.7538 4.79106 -9.45955 4.66587 +2897 4 14.3924 26.7004 12.6499 8.67511 -16.0651 4.90492 +2898 6 54.9632 28.863 3.30225 1.80665 -46.0259 4.02989 +2899 4 54.8334 28.8705 2.33571 2.30679 -1.29159 7.0988 +2900 4 0.250446 27.9134 3.53944 -11.9885 37.0888 -10.0107 +2901 6 17.2065 5.13222 2.58226 -24.5489 -19.7693 -14.9516 +2902 4 17.8239 4.45011 2.8785 5.4716 1.45995 5.40018 +2903 4 17.4096 5.93537 3.0482 10.2082 3.99522 6.08435 +2904 6 50.7076 33.0524 10.3335 3.48719 10.0002 9.95533 +2905 4 50.6136 33.804 9.75033 0.0726689 14.8217 2.89741 +2906 4 50.6632 32.3255 9.72979 -1.7797 -23.5385 -6.20373 +2907 6 28.8719 19.8379 32.3662 12.2168 9.43689 -9.94144 +2908 4 29.8293 20.0527 32.223 -26.7315 -2.75674 4.09206 +2909 4 28.3919 20.677 32.2058 6.96369 -8.55206 2.54368 +2910 6 22.4258 12.8301 23.3099 -21.9068 12.8519 23.6974 +2911 4 22.5424 12.4187 24.2055 -3.2327 9.70973 -17.8182 +2912 4 21.6904 13.4906 23.4219 18.0295 -16.5223 -3.23075 +2913 6 54.7859 15.5473 8.87871 3.42684 8.57095 -7.37477 +2914 4 0.5152 15.244 9.45304 -3.41058 -4.28924 6.32649 +2915 4 53.9742 15.1056 9.16818 6.16615 -2.4265 3.01646 +2916 6 10.455 19.2982 26.169 33.281 -8.93788 40.2277 +2917 4 11.227 18.6906 26.1605 -15.5014 12.2348 -4.03004 +2918 4 10.0694 19.2521 25.3251 -19.4777 -1.76614 -41.28 +2919 6 38.6541 20.3016 35.2246 25.1317 -2.89776 0.584273 +2920 4 39.6122 20.389 35.0245 -16.8563 1.20482 1.7302 +2921 4 38.6037 19.6498 35.9401 -3.42784 5.37932 -3.92632 +2922 6 17.4847 18.0451 15.2473 -2.11698 43.6037 15.5575 +2923 4 17.3165 17.6253 14.4157 -4.81229 -12.7227 -25.2707 +2924 4 17.3243 19.0143 15.0283 6.45297 -29.0578 8.37137 +2925 6 29.6412 0.96029 26.2538 -2.92598 -32.1867 -14.968 +2926 4 29.2295 1.80722 25.9783 -5.05853 -19.2177 -5.0061 +2927 4 29.2302 0.136786 25.7855 11.2507 47.838 14.1271 +2928 6 30.4583 12.6781 28.2933 9.80318 -11.3268 12.128 +2929 4 29.9046 13.1756 27.6811 -9.35495 -4.05719 -6.55314 +2930 4 30.1425 11.7563 28.3949 -4.92949 12.905 -7.65094 +2931 6 36.6582 22.1039 33.3564 18.5548 3.44171 -30.7077 +2932 4 37.613 21.8793 33.4826 -21.695 5.78572 4.26475 +2933 4 36.1698 21.8632 34.1249 -2.38139 -6.6943 29.4942 +2934 6 34.851 22.4634 14.295 34.3706 -12.4795 -36.6647 +2935 4 34.1306 22.5878 14.8998 -26.9044 -0.864951 1.69223 +2936 4 34.6097 22.0485 13.4154 -10.7342 10.9778 31.0087 +2937 6 15.5278 9.60588 7.43972 42.9889 -30.8008 -13.2318 +2938 4 16.5289 9.52064 7.17624 -51.4641 3.68278 11.9177 +2939 4 15.1523 8.68078 7.51431 10.3517 24.0811 1.24627 +2940 6 21.8097 28.0449 19.8036 -9.3837 2.2861 -3.69714 +2941 4 21.8234 28.4749 20.6579 1.49564 5.45585 8.79124 +2942 4 20.892 27.7474 19.715 3.3935 -2.50466 0.747966 +2943 6 34.5377 24.4067 2.43307 17.6783 -35.0943 7.08511 +2944 4 34.5604 23.3833 2.29911 9.6022 45.0517 12.0591 +2945 4 35.2671 24.6922 3.07368 -22.5652 -15.0324 -19.8681 +2946 6 12.5974 20.9324 33.5156 -46.2472 -18.3539 -4.34371 +2947 4 11.7028 20.621 33.8238 24.9199 8.0821 6.3307 +2948 4 12.4411 20.8933 32.5604 17.1824 5.4367 5.76912 +2949 6 45.7726 31.1546 8.70236 -14.9606 25.5026 -0.599968 +2950 4 45.9029 32.1319 8.75243 4.68257 -18.3747 -3.63409 +2951 4 44.8252 31.0158 8.86685 6.58294 -2.27884 -1.49072 +2952 6 15.4856 22.546 30.183 -27.3843 -7.95278 -8.87715 +2953 4 16.2041 23.1276 30.4314 15.0704 -4.03687 4.09321 +2954 4 15.7065 21.6006 30.174 10.2057 11.8959 3.83923 +2955 6 39.7496 17.1848 38.4183 10.7213 7.86871 6.49434 +2956 4 39.4778 16.5926 37.6964 5.17631 5.73732 3.80123 +2957 4 40.5328 17.6892 38.1152 -12.3514 -12.5856 -1.70264 +2958 6 14.0114 24.6894 0.67727 2.36324 3.45559 -2.63023 +2959 4 14.2236 24.5974 1.61702 0.728832 5.12592 -0.706901 +2960 4 14.3876 25.5307 0.374588 3.08684 -2.75846 6.71077 +2961 6 31.517 19.5744 3.57234 -39.7066 16.7987 -9.47084 +2962 4 30.9812 19.3042 4.35775 22.6375 1.42354 -10.5596 +2963 4 32.4299 19.3292 3.64982 19.3858 -12.3464 7.87151 +2964 6 36.0836 25.0594 19.4567 -36.7914 6.39304 28.0525 +2965 4 37.0156 25.1955 19.4145 23.7106 3.97855 -3.98164 +2966 4 35.8434 24.7134 18.6052 0.797557 -6.28507 -17.3783 +2967 6 51.6689 17.6827 14.8094 17.1445 12.5774 26.8045 +2968 4 51.9037 18.5572 15.2299 -9.72171 -22.1194 -12.5657 +2969 4 51.1779 17.9239 14.0295 -8.26923 9.08158 -15.405 +2970 6 37.7112 27.5006 38.1887 12.9616 35.4771 9.449 +2971 4 37.6633 26.7956 37.5532 1.11487 -12.4995 -15.1422 +2972 4 38.1924 28.2458 37.7567 -11.1334 -22.4905 3.32353 +2973 6 34.7974 13.8528 30.7792 38.2139 14.8122 -13.8353 +2974 4 35.0479 14.6237 31.2931 10.1718 6.91547 -1.09557 +2975 4 34.0108 13.6012 31.1887 -47.9834 -23.6229 17.9792 +2976 6 19.6227 37.378 39.9679 -4.73731 -6.94245 -18.3615 +2977 4 20.5687 37.4692 40.1123 7.88808 5.09103 7.87528 +2978 4 19.5641 36.8976 39.1176 -6.21843 3.50671 7.67834 +2979 6 40.9479 34.0678 21.4433 -0.249567 -14.1225 -18.8789 +2980 4 41.1016 33.9428 22.3797 -2.14769 -1.67588 5.36328 +2981 4 40.6839 33.1793 21.1286 -1.36491 12.9737 -0.808456 +2982 6 32.9563 27.2052 26.5619 16.765 25.3633 38.6423 +2983 4 33.6584 27.782 27.0193 -28.2502 -21.1678 -18.3317 +2984 4 33.3196 26.985 25.7164 10.2198 -2.00428 -21.725 +2985 6 24.4119 18.6722 15.6191 2.60565 2.56356 0.790403 +2986 4 23.5591 19.1036 15.7005 -5.06369 4.62453 -0.705819 +2987 4 24.5532 18.2558 16.4735 3.02917 -4.75652 8.16225 +2988 6 29.9677 1.63803 9.07283 -8.6377 39.5876 -9.34009 +2989 4 30.0634 0.720354 9.20948 2.18912 -36.9171 5.61628 +2990 4 29.1461 1.70687 8.54641 9.48634 -0.985828 6.78106 +2991 6 31.4838 20.0989 7.86304 35.53 0.0326438 -30.7549 +2992 4 32.0429 19.6076 7.17649 -26.3889 9.76992 30.1887 +2993 4 30.8408 19.4752 8.19414 -7.49558 -12.7978 -1.24617 +2994 6 35.0504 3.77818 33.2765 0.0823497 -0.922868 12.9261 +2995 4 34.3448 4.25588 32.7981 8.7563 -3.59111 2.91721 +2996 4 34.8655 3.9194 34.2319 -2.64551 -3.11561 -17.2257 +2997 6 43.9652 7.96842 12.9746 -1.99776 -12.8019 0.966431 +2998 4 43.3695 7.30717 13.3748 13.3395 3.08022 -2.86187 +2999 4 43.3917 8.71398 12.8108 -3.39849 12.2944 -1.42541 +3000 6 44.1076 32.6848 16.9531 4.83347 14.0385 -4.8226 +3001 4 44.7886 33.3699 16.7553 -9.08835 -13.3706 7.91806 +3002 4 44.1269 32.547 17.9059 1.63547 3.97279 4.50154 +3003 6 40.604 27.1617 19.037 5.49217 0.683783 -24.0967 +3004 4 39.907 26.5243 18.7614 10.7357 10.4426 0.818988 +3005 4 41.0572 27.5561 18.2306 -16.7517 -14.1941 23.9583 +3006 6 46.0503 23.2068 29.0603 33.2935 27.7725 23.492 +3007 4 46.7239 23.8517 29.4252 -26.0483 -15.0892 -12.6312 +3008 4 46.5249 22.3737 28.9794 -1.25341 -9.22801 -2.13192 +3009 6 42.6264 30.606 18.8462 -34.271 -0.881878 -8.8004 +3010 4 43.5242 30.7893 19.1074 18.3218 -5.88078 -5.57768 +3011 4 42.5428 29.9264 18.1492 10.4183 2.57162 5.03187 +3012 6 36.1231 10.8975 23.2614 14.248 33.6052 6.96597 +3013 4 35.2264 11.248 23.1278 1.11349 -2.62395 -2.03304 +3014 4 36.6438 11.7125 23.5215 -18.5882 -27.5405 -10.5609 +3015 6 13.7387 31.5187 15.7175 -8.63655 -3.85126 -4.64142 +3016 4 14.6788 31.7096 15.8046 0.813603 4.25462 -2.48371 +3017 4 13.3439 32.0503 15.0041 7.14664 -1.81478 4.34843 +3018 6 33.1663 41.4263 27.7844 10.1514 -8.73892 50.1834 +3019 4 33.0558 0.0915148 27.0508 0.335607 20.6114 -25.4934 +3020 4 33.386 0.0476391 28.6 -4.59167 -12.6797 -24.4066 +3021 6 32.8924 22.9248 31.4777 14.8331 -14.2772 -3.0724 +3022 4 32.331 22.9976 30.6823 -4.11553 14.0534 8.76104 +3023 4 32.7731 23.648 32.1168 -12.639 5.72297 -14.9522 +3024 6 27.6514 16.8629 6.392 5.9792 -3.02818 28.7598 +3025 4 27.8554 17.3015 5.57876 -0.492343 9.99532 -20.1105 +3026 4 26.7867 16.4634 6.29535 -11.4685 -3.6273 -5.68351 +3027 6 47.2692 11.6326 26.0701 -7.51592 -12.561 -4.95541 +3028 4 47.0451 11.5188 27.0189 12.1951 16.3083 -15.426 +3029 4 47.7234 12.4489 25.7723 -5.45211 -2.19527 19.0308 +3030 6 27.5533 7.05227 7.64253 19.1893 -9.34804 28.5196 +3031 4 26.7486 7.45205 7.94122 -22.9318 8.15137 -1.85106 +3032 4 28.0959 7.04706 8.46187 -1.51515 -0.839126 -23.0353 +3033 6 39.7861 9.0687 11.9758 -15.1444 6.22431 -7.98147 +3034 4 39.495 9.25597 11.0599 4.77492 -2.72739 13.3066 +3035 4 38.9879 9.23938 12.5098 3.46881 -0.389139 -2.20355 +3036 6 18.1894 33.4728 36.1008 -27.5283 -9.1571 7.06889 +3037 4 17.6722 33.9726 35.425 4.94426 -9.47891 13.9641 +3038 4 17.5468 32.9442 36.6812 19.6546 19.0371 -24.2711 +3039 6 37.1945 26.5569 0.720807 -12.4444 8.19753 -2.53971 +3040 4 37.3568 25.6462 0.476597 4.7119 -6.04631 0.679389 +3041 4 36.2336 26.6328 0.585525 8.76389 3.8419 -0.879611 +3042 6 44.2004 19.6233 36.8917 26.7932 -13.3754 0.0595121 +3043 4 45.0387 19.0956 36.766 -19.227 18.7818 5.02367 +3044 4 44.4376 20.5683 36.9644 1.27086 -9.01627 -1.91077 +3045 6 27.7799 6.35317 35.6882 16.2858 -3.70231 1.18314 +3046 4 27.1634 6.96571 35.2926 -9.46908 3.45363 -4.90602 +3047 4 27.3042 5.53742 35.858 -2.00694 0.00942349 2.38052 +3048 6 34.7653 16.4924 20.8795 20.4023 -19.0949 10.3746 +3049 4 35.5516 15.8729 20.9898 -30.5098 25.2475 -4.70775 +3050 4 34.1298 16.2162 21.5757 7.90375 5.70636 -13.0995 +3051 6 39.0303 20.9673 40.4307 -20.4786 -67.2325 12.8224 +3052 4 38.8254 20.089 40.9106 11.5443 40.6977 -30.184 +3053 4 39.2642 21.5386 41.1412 8.11615 27.562 18.514 +3054 6 10.8068 27.9205 1.65866 27.4379 7.91142 -24.506 +3055 4 10.0967 27.7204 2.22826 -30.9372 -12.069 25.0324 +3056 4 10.8782 28.8813 1.73209 2.10338 1.16742 -2.23752 +3057 6 47.025 23.1272 13.2603 -26.8307 -11.5375 0.419605 +3058 4 47.6563 23.6094 12.7175 1.22463 1.60122 -3.88323 +3059 4 46.2701 22.846 12.6737 25.4538 5.98786 18.4886 +3060 6 34.5769 28.3999 10.6617 -26.3731 9.09486 -11.6064 +3061 4 34.5145 27.7223 11.3448 13.7244 -2.44185 1.37306 +3062 4 35.5023 28.5375 10.4336 6.33869 -4.76798 1.2135 +3063 6 3.33738 17.579 14.2816 -4.12164 13.1786 -2.02309 +3064 4 3.51487 16.7052 14.5979 -0.480238 -24.8864 6.17379 +3065 4 3.96197 18.0965 14.8055 -3.35437 6.17503 -1.46632 +3066 6 27.7248 11.5976 7.52038 4.0705 34.1711 4.34085 +3067 4 27.7194 12.5939 7.6487 2.26317 -33.1326 -4.66749 +3068 4 27.2616 11.2314 8.28138 -1.22149 -2.70865 2.4378 +3069 6 41.4317 28.339 9.02961 12.1835 18.6619 -21.5911 +3070 4 40.932 28.9387 9.57928 -8.65956 3.59764 13.3257 +3071 4 41.6711 28.9179 8.26221 -0.754142 -18.9314 12.3863 +3072 6 42.0732 4.78493 8.18399 0.592074 10.501 -23.0953 +3073 4 42.2656 5.73441 7.90258 -4.03181 -32.5079 3.94615 +3074 4 41.9391 4.19656 7.39311 5.50228 24.8072 19.85 +3075 6 28.4553 8.6408 40.3288 -1.1592 2.81238 -0.593175 +3076 4 27.8014 8.47839 41.05 3.29603 2.13238 -25.5829 +3077 4 28.0374 8.68456 39.4248 -2.58083 -3.24862 30.0681 +3078 6 0.723272 18.248 15.2854 4.61761 3.31073 11.0333 +3079 4 1.58056 18.1517 14.8782 17.0637 -0.561901 -5.4503 +3080 4 0.169553 17.7112 14.727 -13.9143 -7.94922 -7.42873 +3081 6 7.11829 16.2161 40.455 0.573222 -5.60735 -16.9123 +3082 4 7.21814 15.2583 40.7035 1.10072 25.2259 14.7352 +3083 4 7.17549 16.8833 41.1741 1.82325 -21.1089 2.38217 +3084 6 41.0856 8.6232 20.9154 1.44565 10.3804 -0.748136 +3085 4 40.3857 8.53297 20.2693 -12.0873 -13.8416 -3.91841 +3086 4 41.3541 9.53003 20.731 8.87844 6.62655 8.68036 +3087 6 31.7065 7.41805 37.5384 1.8504 0.880847 10.656 +3088 4 31.4927 7.12037 36.644 -5.569 -4.06437 0.235955 +3089 4 30.9766 7.14703 38.1182 6.88034 1.43502 -8.9471 +3090 6 40.7175 11.6353 25.4105 -5.83472 20.1078 -6.29096 +3091 4 40.8441 12.5768 25.6218 -9.59803 -8.51017 -7.38463 +3092 4 41.5254 11.2592 25.7328 13.3582 -17.7026 5.353 +3093 6 29.8893 30.1615 6.66958 6.45784 -4.04896 -4.41327 +3094 4 30.5285 30.6751 6.15191 0.92206 -5.81994 -1.29615 +3095 4 30.2313 29.249 6.64761 -0.535397 8.70224 -1.24193 +3096 6 40.83 24.591 5.67679 17.1105 23.9162 -4.99229 +3097 4 41.4401 25.3556 5.89599 -18.0089 -21.1831 -4.73113 +3098 4 40.1352 24.5742 6.32932 -4.29697 2.2625 8.62223 +3099 6 34.3954 9.09122 20.4203 -0.702674 2.95809 7.47625 +3100 4 33.5897 9.50113 20.7506 -0.63314 5.38769 7.97821 +3101 4 34.107 8.76785 19.5728 -0.194313 -9.82044 -16.4611 +3102 6 18.2164 33.5433 26.5438 32.3972 -29.6611 -30.5808 +3103 4 19.1929 33.4142 26.4527 -23.3283 -2.37285 -6.48837 +3104 4 18.1915 34.0681 27.3044 -13.0981 29.1765 42.7321 +3105 6 28.9207 17.4075 26.7926 -1.66434 -4.11711 9.90999 +3106 4 28.2497 17.0259 26.21 0.151798 0.605301 -3.15085 +3107 4 28.4243 17.7127 27.5796 8.50802 -3.38176 -8.48604 +3108 6 50.4389 35.5612 18.195 -0.220837 -24.3132 -9.08897 +3109 4 50.4331 35.2145 17.2813 -0.853004 14.3463 8.17747 +3110 4 50.3692 34.7248 18.6968 -4.07606 17.1918 3.62275 +3111 6 2.99582 21.5586 31.4575 0.708202 -18.646 -28.6731 +3112 4 3.24926 22.2892 30.8424 -5.67023 -11.8068 12.1364 +3113 4 2.8516 20.7624 30.8616 4.12476 24.3831 20.6408 +3114 6 36.1857 18.7483 8.60511 9.96184 26.1081 -2.68835 +3115 4 36.1356 17.8778 8.93402 3.95956 -36.7917 21.724 +3116 4 35.6171 18.7388 7.85438 -14.2398 9.24248 -24.4438 +3117 6 20.2742 6.47995 33.7286 -0.427153 4.78104 -4.08195 +3118 4 19.8935 6.35632 34.6244 -2.14212 -11.6635 -12.611 +3119 4 20.0876 5.70362 33.1559 -1.45185 1.76636 16.8362 +3120 6 13.9952 30.5211 6.65468 -0.834568 0.374695 7.89925 +3121 4 14.6781 31.0539 7.1149 -10.4447 -7.07426 -7.17019 +3122 4 13.1432 30.7212 7.07951 7.79461 1.02333 -2.73826 +3123 6 36.2732 16.4484 35.7639 18.345 14.0335 0.961522 +3124 4 37.2268 16.2475 35.9495 -24.6333 8.21497 -3.5549 +3125 4 36.1837 17.4253 35.5797 7.74798 -29.1845 4.36862 +3126 6 45.8208 37.6575 9.69399 14.3507 -31.8621 -27.6249 +3127 4 45.4608 38.3019 10.268 -8.06385 16.394 26.7739 +3128 4 46.3975 37.0305 10.1733 -1.81999 10.6315 0.898341 +3129 6 47.4165 17.984 27.6369 4.10759 -46.3966 -5.45297 +3130 4 47.5682 17.4629 26.7823 -7.01073 17.4072 30.8444 +3131 4 47.4562 17.3293 28.4007 0.542452 20.9274 -25.5144 +3132 6 25.9608 18.2932 0.952258 -4.39486 21.5955 18.9376 +3133 4 26.1989 18.9101 1.66086 12.5057 -8.35286 -7.15646 +3134 4 25.0082 18.3237 1.04468 -12.1408 -13.2893 -13.6751 +3135 6 27.3648 22.4066 4.28268 2.26175 -24.9034 0.419816 +3136 4 27.3706 23.3409 4.46802 1.80952 16.8807 -5.51915 +3137 4 27.3027 22.2785 3.32806 -2.77408 5.10873 4.5687 +3138 6 3.39125 3.84856 27.607 3.69966 -10.1033 0.490887 +3139 4 4.0137 4.55908 27.5406 6.78149 24.6072 0.911673 +3140 4 3.97847 3.09168 27.5281 -8.4044 -12.3732 0.103181 +3141 6 45.3633 27.6554 28.8452 2.12727 -1.25659 10.7713 +3142 4 44.5282 27.2015 28.6866 -4.83999 -4.58212 3.48715 +3143 4 45.3811 28.2979 28.14 4.63148 6.41932 -6.37453 +3144 6 28.4005 32.3772 16.2203 23.7034 -3.75626 0.763822 +3145 4 29.2297 32.2225 15.6968 -18.0553 4.16843 14.9752 +3146 4 28.6795 32.6874 17.1033 -0.325788 -1.29005 -11.6373 +3147 6 9.90477 33.835 13.0292 3.70295 -3.7397 30.9684 +3148 4 9.58558 33.3049 13.7992 6.56164 12.5415 -12.6178 +3149 4 9.32425 33.6546 12.2978 -12.2649 -3.83445 -16.8068 +3150 6 38.3301 26.6316 14.917 8.16845 -9.374 -1.40965 +3151 4 38.7482 25.7736 15.154 -10.3234 14.7528 -2.05039 +3152 4 37.3847 26.6122 15.1206 3.66029 -5.29 2.35016 +3153 6 31.3553 16.3729 4.24558 -11.5598 -13.3523 13.2112 +3154 4 30.5395 15.8971 4.54084 13.4071 7.11555 -7.19651 +3155 4 31.205 16.607 3.32285 -2.62497 2.93757 -4.30077 +3156 6 6.17611 3.41063 6.5613 17.7272 3.64487 37.5473 +3157 4 6.46982 3.08663 7.46094 -9.0795 17.2981 -27.883 +3158 4 6.02642 2.6045 6.08389 -2.81663 -13.5692 -12.3872 +3159 6 42.5919 12.9938 5.62253 0.302259 -11.3067 -0.460125 +3160 4 42.3001 13.8766 5.84478 4.87778 6.39543 1.2284 +3161 4 43.5084 12.9049 5.92305 -2.35353 0.46184 -1.33783 +3162 6 41.0467 31.3953 33.7949 3.79599 37.3117 5.16998 +3163 4 40.7289 31.3961 34.7173 5.05156 -5.30154 -15.2916 +3164 4 41.2174 32.3636 33.5809 -4.47671 -37.1445 4.47908 +3165 6 52.8595 12.0576 26.2617 4.7779 -12.5882 -49.4794 +3166 4 52.3971 12.713 26.7564 -13.8804 18.303 15.9364 +3167 4 52.6839 12.2865 25.2977 8.87889 -9.64762 29.5111 +3168 6 39.2197 4.29237 29.0569 11.235 6.95972 3.08537 +3169 4 38.4782 4.84799 29.3396 4.36118 -6.50894 -4.0878 +3170 4 39.9967 4.59393 29.5615 -4.77927 -7.36273 -4.89832 +3171 6 3.64414 27.0065 11.2815 -12.9441 10.9516 -6.43872 +3172 4 4.59106 26.8908 11.2849 14.3058 -9.72403 4.26042 +3173 4 3.53535 27.8319 10.7781 -8.82957 -2.80904 -0.131447 +3174 6 41.5421 29.6442 25.2671 -5.6293 3.19366 2.66863 +3175 4 41.8684 29.6903 24.3723 12.1179 -3.11764 -10.4285 +3176 4 40.7194 30.1326 25.2057 -6.30215 2.63585 1.74894 +3177 6 50.468 27.487 30.6705 -3.05594 -10.4468 2.57161 +3178 4 50.076 27.1594 31.5009 0.806547 4.01213 -5.24181 +3179 4 49.8217 28.0451 30.2184 -2.62753 1.96724 1.87939 +3180 6 32.7902 33.6258 41.7496 -4.87138 -4.97834 -25.0012 +3181 4 33.1641 32.7497 41.8541 3.47816 -11.5824 1.65798 +3182 4 32.8969 34.0586 0.665858 3.16614 12.7166 21.4132 +3183 6 5.9796 9.64598 7.93234 5.57207 13.1841 -10.7861 +3184 4 5.80592 9.95912 8.82583 -0.986272 -0.521215 4.5825 +3185 4 6.43021 10.3852 7.47125 -1.05258 -10.6241 3.31462 +3186 6 52.774 25.3768 27.6816 12.7732 -3.18466 28.0173 +3187 4 52.93 26.2779 28.0237 -8.60677 -10.695 -13.1321 +3188 4 53.2011 24.8527 28.4031 -8.37753 -2.27765 -26.5487 +3189 6 18.6947 23.2095 14.4724 -28.0966 8.43578 15.8218 +3190 4 18.5587 24.1605 14.7523 20.6562 -24.296 -13.1918 +3191 4 19.5669 23.0215 14.1303 11.4888 10.4676 -1.8787 +3192 6 31.2862 9.0706 13.0896 18.8649 -43.5027 -8.26415 +3193 4 31.2854 8.18164 13.5153 -0.98006 14.2242 -7.24428 +3194 4 30.8139 9.64196 13.6614 -21.2648 23.3567 24.384 +3195 6 52.8349 16.8368 29.9626 -1.04236 -5.83632 -3.7224 +3196 4 53.1314 16.3317 29.1809 4.11254 10.2245 6.81583 +3197 4 53.5336 17.4658 30.2088 5.59995 -2.32318 -6.64835 +3198 6 13.48 30.6403 11.9185 -26.7 12.8254 18.6299 +3199 4 12.8874 31.2649 12.4086 6.11749 -21.3055 -11.69 +3200 4 14.2712 31.1662 11.9231 18.3999 3.72963 -5.07782 +3201 6 24.4118 24.6653 11.1776 -11.0488 -38.9105 0.0232616 +3202 4 25.2327 25.0345 11.4834 15.6111 8.28781 8.86477 +3203 4 24.5324 23.6736 11.237 -9.01076 27.817 -2.51724 +3204 6 11.1207 26.7925 5.93063 -6.41259 2.09364 -8.23675 +3205 4 11.5241 26.98 6.79711 -3.12879 8.72791 -6.17468 +3206 4 10.8719 27.6544 5.50988 6.7003 -18.2386 15.7162 +3207 6 12.0069 32.3194 4.56559 -6.93674 1.89769 -53.2748 +3208 4 11.7104 31.8608 3.68045 16.1117 25.2499 46.2442 +3209 4 12.3686 33.2222 4.3326 -9.20365 -26.1492 2.14142 +3210 6 6.43611 5.48582 30.4705 10.9412 7.27018 -5.81208 +3211 4 6.8324 6.31983 30.1884 15.302 -0.761667 0.276275 +3212 4 5.5204 5.70213 30.4126 -22.6187 -2.98333 3.5448 +3213 6 38.1723 39.6045 29.3805 -11.1368 -0.968084 -7.99101 +3214 4 37.5332 40.3179 29.1036 12.1085 -24.1545 -0.917311 +3215 4 37.9804 38.7063 28.9788 -2.28765 36.4506 5.30967 +3216 6 52.5924 19.3736 5.41149 4.12965 0.0949992 -5.17576 +3217 4 52.3027 20.2712 5.07121 22.7239 -28.0308 -2.84369 +3218 4 53.4989 19.0543 5.10701 -28.7609 25.7225 2.66162 +3219 6 18.3561 9.81057 21.0683 -18.476 -24.6523 15.6829 +3220 4 17.6378 9.45854 20.4828 20.1245 14.4878 5.80252 +3221 4 19.033 10.2869 20.5982 6.82627 10.6552 -20.9713 +3222 6 14.5094 41.1238 15.0395 5.73538 -4.06503 -13.1796 +3223 4 15.2839 41.068 15.6075 4.55031 0.900939 7.74817 +3224 4 13.875 41.6599 15.5263 0.0235554 2.15182 4.98288 +3225 6 36.0027 23.903 26.7597 7.48895 21.6763 -35.676 +3226 4 35.8975 23.6043 27.6465 2.36908 -17.7227 17.2904 +3227 4 36.3267 23.2124 26.1374 -7.97178 4.49324 27.7844 +3228 6 35.6359 10.4157 26.2529 -13.2839 -25.1837 23.1485 +3229 4 35.969 10.5098 25.3716 5.3977 0.436992 -21.1808 +3230 4 35.4229 9.45302 26.3798 5.18698 20.1527 -7.56493 +3231 6 45.3037 24.2791 20.2723 9.06075 11.2998 -13.4968 +3232 4 45.4523 24.978 19.6109 10.2075 -1.49386 4.95329 +3233 4 44.5125 23.8555 19.9662 -13.3892 -9.58217 -2.04663 +3234 6 15.8107 39.0453 24.2393 9.7405 19.086 8.48056 +3235 4 15.3407 39.8143 24.6455 3.07287 -17.6695 -6.90152 +3236 4 16.7434 39.3626 24.1878 -22.1708 -8.11019 0.25747 +3237 6 4.61074 25.9041 16.8066 4.47487 12.325 4.32837 +3238 4 5.33363 26.3313 17.2996 -1.16871 -8.95741 -3.63592 +3239 4 3.89121 26.5439 16.91 5.27726 -3.71411 -3.28281 +3240 6 33.4791 9.99232 32.5716 -36.5508 -4.76722 -31.2046 +3241 4 34.3147 10.2419 32.89 39.2476 10.968 21.6954 +3242 4 33.0188 9.57531 33.3002 0.324125 -5.12222 10.2577 +3243 6 22.9388 37.5185 1.51191 -4.27166 -24.2064 8.31852 +3244 4 23.0334 38.2273 2.154 1.20614 3.86272 6.71724 +3245 4 22.69 36.6978 2.02191 6.96614 23.4315 -10.5782 +3246 6 39.1324 20.5485 25.4772 25.265 -11.778 19.9951 +3247 4 39.2103 21.4279 25.1215 -1.526 12.0473 -3.88318 +3248 4 39.8813 20.4818 26.1301 -17.748 -0.0581828 -14.4699 +3249 6 25.0622 25.0762 37.6014 21.4558 5.76047 -13.7935 +3250 4 26.0349 25.2337 37.6294 -19.4467 -8.38624 -4.14531 +3251 4 24.8891 24.8197 38.5048 -7.65564 -1.94532 12.2316 +3252 6 12.209 35.7591 11.4203 -9.12536 1.25056 -5.53999 +3253 4 11.4995 36.2015 10.8899 19.2305 -11.6187 8.3526 +3254 4 12.8486 35.4161 10.7797 -5.71729 7.89629 -2.43108 +3255 6 42.046 15.7235 20.1276 29.9467 5.46844 -26.2367 +3256 4 42.5818 15.5034 19.3148 -14.0105 1.75231 17.5608 +3257 4 42.3615 16.6209 20.337 -4.0808 -2.27778 2.90042 +3258 6 53.2021 25.4307 39.5282 4.69599 -13.2561 7.07883 +3259 4 53.78 25.8541 38.905 5.49131 5.5629 -6.42231 +3260 4 52.4802 26.028 39.6966 -10.1139 9.50655 0.821399 +3261 6 53.7967 21.778 1.29815 15.5744 -8.20383 1.43914 +3262 4 54.6378 21.4326 0.944441 -3.84265 -1.46767 8.18122 +3263 4 53.3536 22.1543 0.542634 -13.037 9.31425 -11.6048 +3264 6 1.93111 22.4438 20.1768 4.00387 4.12813 31.1185 +3265 4 1.5939 23.2361 20.6593 2.49828 -13.4199 -15.2591 +3266 4 2.41139 21.9607 20.8911 -6.34657 6.89732 -14.8434 +3267 6 41.1871 16.1847 11.4932 0.836017 42.0531 1.99799 +3268 4 40.9413 15.3195 11.802 -9.8633 -17.6073 7.87469 +3269 4 40.5377 16.8617 11.8588 16.4331 -27.7799 -8.96912 +3270 6 17.194 38.6096 9.61825 4.75854 -2.20459 -16.4638 +3271 4 17.8324 38.6167 10.328 10.0816 -0.610832 12.429 +3272 4 16.3385 38.6013 10.0398 -14.9506 0.593169 11.9887 +3273 6 33.2005 12.9606 38.531 8.50507 10.8774 -15.8661 +3274 4 33.6532 13.8203 38.39 -7.98235 -13.7359 5.26797 +3275 4 33.1331 12.8007 39.479 5.11874 5.24255 -4.23095 +3276 6 24.7171 21.675 39.9778 2.8762 -23.2501 -10.2076 +3277 4 24.5558 21.597 39.0096 0.45736 0.189324 11.8412 +3278 4 25.3262 20.9394 40.2143 -5.83632 9.86919 -3.30671 +3279 6 13.5803 15.5602 27.3532 26.1047 30.3564 11.1382 +3280 4 13.1676 16.145 28.014 -3.26959 -8.19558 -5.9347 +3281 4 12.973 14.8589 27.1951 -20.4184 -17.1677 1.43072 +3282 6 24.68 18.7128 9.26691 14.3839 36.3501 26.0009 +3283 4 25.3598 19.2552 8.82532 -5.31062 -15.6251 -9.27674 +3284 4 24.5166 19.2286 10.0937 -4.12977 -20.8661 -14.1648 +3285 6 10.971 8.2031 0.0820528 -5.05885 27.6393 52.7366 +3286 4 10.426 8.82187 0.676738 20.6953 -23.692 -21.2054 +3287 4 11.8511 8.19112 0.51746 -10.8092 -0.715691 -8.01276 +3288 6 15.7168 31.9426 31.3882 -16.0589 -14.8784 11.374 +3289 4 14.8784 32.0139 30.9212 -5.19427 4.39929 -5.1125 +3290 4 16.2361 32.7208 31.1626 4.51908 -4.85975 -1.07492 +3291 6 20.3853 39.1678 21.6201 3.96912 1.70678 -2.15463 +3292 4 19.8408 38.4031 21.9136 18.3946 15.2484 5.21077 +3293 4 21.1259 39.3411 22.2478 -18.5683 -14.4588 -3.61544 +3294 6 38.8575 19.5345 7.60357 -3.22682 7.2187 -10.7103 +3295 4 37.9955 19.1157 7.58645 -3.56529 1.50397 -1.646 +3296 4 39.2183 19.2349 8.43232 7.58358 -7.76078 7.45775 +3297 6 41.3566 29.7161 21.1634 -18.4754 -13.1658 17.2704 +3298 4 41.7904 29.7702 20.3348 3.95998 3.00501 -30.3792 +3299 4 42.0386 30.0045 21.7486 9.4821 7.67994 22.7786 +3300 6 50.7055 33.8359 22.0677 10.0235 -14.5617 12.8511 +3301 4 51.0634 32.983 22.4061 -4.7136 19.0099 -8.42991 +3302 4 50.4062 33.6539 21.1646 0.0172424 0.211956 1.78818 +3303 6 18.1576 11.1602 14.3564 -14.1594 -3.53412 4.86119 +3304 4 18.0624 11.3441 15.3149 3.69196 -2.83217 -14.991 +3305 4 19.1071 11.0831 14.1997 2.21718 -0.861887 0.62752 +3306 6 48.509 14.2737 15.2536 -33.8512 -15.7039 -13.3543 +3307 4 49.4102 14.4821 15.4142 31.3042 4.03673 3.1002 +3308 4 48.4635 13.5769 14.5611 0.497508 10.2707 10.4073 +3309 6 32.9892 15.7452 8.24788 15.5762 1.59093 3.47394 +3310 4 33.8184 15.532 7.78513 -5.99942 0.288096 4.45585 +3311 4 33.1922 15.7362 9.20789 -3.05234 -0.622843 -13.6288 +3312 6 42.9176 4.85532 18.7629 14.1748 1.41964 3.40057 +3313 4 42.9882 5.82921 18.9229 4.77982 -22.1758 1.39114 +3314 4 43.8043 4.45344 18.9624 -18.3785 17.0247 -7.93082 +3315 6 10.5031 23.7237 33.4382 -0.874073 19.9298 2.74355 +3316 4 10.5548 24.717 33.3795 7.7257 -28.8706 -7.54496 +3317 4 11.1379 23.281 32.8547 0.735263 11.3428 1.89897 +3318 6 1.13216 20.0583 11.2836 18.374 17.5884 12.1148 +3319 4 0.491024 19.3349 11.1994 -2.17247 3.20995 10.4498 +3320 4 1.13554 20.5377 12.169 -13.4236 -25.5013 -29.3002 +3321 6 1.52072 39.5358 14.3069 -1.86369 -19.4721 11.7014 +3322 4 0.846705 40.1803 14.5938 4.14733 -5.95668 -5.60613 +3323 4 1.29368 38.6598 14.724 6.32152 28.9753 -9.07681 +3324 6 8.31775 21.6111 14.1387 -15.017 -6.93379 31.3726 +3325 4 8.13664 21.1659 15.0266 4.22851 15.111 -30.7591 +3326 4 7.52757 21.5034 13.5919 -1.9589 1.09648 1.01763 +3327 6 7.16491 13.3069 38.2405 -3.91014 1.61314 -29.5843 +3328 4 6.63698 13.0539 37.4502 4.01765 -4.94514 23.7112 +3329 4 7.51249 14.1719 37.966 2.17516 -8.38294 10.659 +3330 6 46.6268 1.62726 18.6981 -5.20766 -2.9114 16.5849 +3331 4 47.5711 1.68468 18.9367 -9.38594 -0.162468 5.90612 +3332 4 46.1191 1.48652 19.5414 20.1897 3.23395 -16.531 +3333 6 4.07867 8.38347 14.797 30.0262 18.9917 2.43531 +3334 4 3.34187 8.3175 15.3794 -25.1937 -7.21885 10.0707 +3335 4 3.92422 7.81173 14.052 -7.87119 -13.0009 -15.9092 +3336 6 47.5843 36.535 17.848 27.4213 12.0237 5.93301 +3337 4 47.2301 35.69 17.6416 -25.9655 -28.1947 -7.00186 +3338 4 48.5203 36.321 17.8356 11.6458 7.4707 2.49139 +3339 6 48.7172 32.6081 3.62434 16.9155 19.6851 -27.3563 +3340 4 49.4676 32.1613 3.18145 -8.8052 -0.0369675 17.0972 +3341 4 48.3534 32.1141 4.33579 -5.12692 -24.8974 22.5299 +3342 6 26.8624 34.4063 15.194 -5.61502 8.38998 -0.355377 +3343 4 27.128 33.6719 15.7603 3.91671 -4.37186 -8.54489 +3344 4 27.3784 34.3384 14.3661 -3.09932 -5.4603 13.6569 +3345 6 9.98983 27.3411 13.3236 -5.30345 -60.6937 -19.0037 +3346 4 9.94192 28.2179 13.0053 -1.51785 37.2293 -13.4128 +3347 4 9.87191 26.7487 12.5139 4.66007 24.2176 27.9858 +3348 6 2.39898 26.8872 37.357 1.59401 -7.29113 19.9813 +3349 4 2.39832 26.7504 38.3162 -5.28205 -0.510768 -0.23331 +3350 4 3.33711 26.9514 37.1904 14.8183 3.44774 -11.9786 +3351 6 33.3368 17.2756 36.8005 -23.2882 7.84328 1.94786 +3352 4 32.371 17.4043 36.8526 5.24602 0.476467 11.7287 +3353 4 33.4423 17.1515 35.8622 12.5187 -3.29866 -15.2334 +3354 6 10.6624 18.8035 9.30575 -3.98781 15.2275 -14.7508 +3355 4 10.7339 18.764 8.32616 -2.59554 -5.92059 15.2764 +3356 4 10.8972 19.732 9.49452 -1.55193 -6.4517 3.37647 +3357 6 8.57833 27.4047 3.14019 -5.09403 -6.13324 -2.85576 +3358 4 8.57126 27.6547 4.08504 -2.7611 -8.03155 -6.83353 +3359 4 8.4622 26.4231 3.09919 3.19624 23.0742 12.9307 +3360 6 40.6073 33.9264 14.3399 -6.85038 20.2562 -23.9123 +3361 4 40.863 33.245 14.948 0.807967 -8.16399 15.1571 +3362 4 40.0779 34.5716 14.8204 -0.495244 -4.69725 4.10141 +3363 6 53.9925 16.7992 13.6308 6.31935 -7.9338 28.1888 +3364 4 54.0997 17.1551 12.7528 -11.031 14.1585 -18.9596 +3365 4 53.1709 17.0486 14.0912 -3.14305 7.59696 -13.573 +3366 6 39.1497 38.4912 7.40608 -39.1223 4.05884 30.5073 +3367 4 38.8859 38.5922 6.48797 -2.00378 4.08479 -3.77896 +3368 4 38.3062 38.5986 7.97667 35.5804 -2.74434 -28.8566 +3369 6 42.2129 33.6808 29.0138 -24.1371 3.42921 -11.8129 +3370 4 42.1057 34.6378 28.7577 -2.98627 -25.8941 0.854821 +3371 4 41.3475 33.1819 28.8496 28.8118 27.0492 8.45917 +3372 6 2.85866 0.0629173 20.1315 -20.2536 1.52979 -19.4947 +3373 4 2.75203 0.421025 19.2221 8.85994 -2.20895 9.93397 +3374 4 1.96017 41.6124 20.299 15.6791 2.4666 6.01858 +3375 6 24.986 26.9373 24.4454 -5.13687 18.0728 7.96565 +3376 4 25.2851 26.0172 24.3926 4.88984 -3.86206 4.04103 +3377 4 25.2923 27.4081 25.2509 0.579281 -17.4573 -11.648 +3378 6 13.6179 33.9875 7.01366 -9.87556 12.4155 -39.0476 +3379 4 14.4287 33.6264 6.65472 5.99816 -4.92128 6.68342 +3380 4 13.2096 34.3429 6.17379 4.4552 -5.00021 31.0775 +3381 6 17.6494 31.8378 3.38868 3.47258 32.8259 -24.0658 +3382 4 17.3179 32.0585 2.49435 6.00696 -1.44586 18.975 +3383 4 17.3532 30.9566 3.5196 -11.0767 -31.773 11.9025 +3384 6 31.1111 29.8483 35.9167 13.6376 7.61418 -14.6842 +3385 4 30.4141 29.611 36.5018 -19.519 -6.65958 16.6428 +3386 4 31.8988 29.4329 36.2727 4.98993 0.410401 2.8928 +3387 6 31.4643 1.69164 1.93808 20.5111 47.6543 28.2436 +3388 4 30.8038 1.05919 1.86135 -35.916 -50.7273 -13.0106 +3389 4 30.9957 2.32106 2.5233 13.9145 -2.66096 -10.7861 +3390 6 13.7147 9.36591 12.3063 -10.8769 -31.3803 3.40225 +3391 4 14.006 10.2311 12.0687 5.19854 25.7457 4.3425 +3392 4 13.2135 9.34561 13.1466 7.78847 9.513 -6.56361 +3393 6 15.2882 15.1512 12.1315 -28.7349 -8.10496 1.75886 +3394 4 14.285 15.1274 12.2085 32.3197 -4.02875 -3.81405 +3395 4 15.5527 14.5676 11.4001 -6.69875 1.91641 1.76342 +3396 6 44.9132 30.4441 13.088 -39.1187 -0.31911 18.6923 +3397 4 45.3561 30.6438 13.8967 -2.95974 2.37903 28.1101 +3398 4 45.6316 30.4633 12.5179 38.3165 -3.24606 -51.9295 +3399 6 35.1465 37.623 24.8576 -14.1582 -15.7359 28.7413 +3400 4 34.5779 38.3725 25.1706 10.6028 -16.3472 -5.82963 +3401 4 34.9593 36.856 25.4995 5.71155 29.9045 -22.7235 +3402 6 43.8948 19.2936 12.9987 -2.30513 -18.2146 13.0469 +3403 4 43.787 18.3102 12.9069 2.76315 21.1578 4.09431 +3404 4 44.375 19.4187 13.8444 -6.58761 -4.34429 -6.9628 +3405 6 14.1971 27.3925 16.8971 2.69526 11.3314 -20.1154 +3406 4 13.4533 26.7979 16.9981 -2.42546 -10.6182 5.16389 +3407 4 14.0783 27.734 15.9851 5.1255 -3.8968 13.4589 +3408 6 5.08574 37.4729 15.7377 1.34169 3.72011 38.8669 +3409 4 5.88395 37.4897 16.2981 -4.65405 2.63162 7.63907 +3410 4 5.46406 37.2335 14.9215 11.9791 -13.9554 -41.5179 +3411 6 35.4862 36.9766 33.2333 -36.83 -5.70901 2.9599 +3412 4 36.4114 37.1444 33.1615 28.5824 10.2327 4.96708 +3413 4 35.1164 37.4942 33.9725 5.15458 -1.79752 -2.84758 +3414 6 6.636 31.7097 32.9848 -22.7133 -7.33235 -24.9389 +3415 4 7.22761 30.9741 32.8206 4.14198 -5.34147 5.16294 +3416 4 6.9999 32.2337 33.6789 14.5784 9.31919 13.8511 +3417 6 31.283 20.2175 25.4647 -9.91499 -1.61286 9.73388 +3418 4 30.5344 20.24 26.1037 18.6204 0.149313 -5.83605 +3419 4 30.8734 20.4846 24.6365 -0.167457 4.09649 -2.99843 +3420 6 54.9487 26.0868 7.35258 -28.6285 -0.216784 1.76255 +3421 4 54.2955 26.5615 6.794 6.74078 -5.97369 7.99882 +3422 4 54.4034 25.6757 8.0611 9.89476 6.61779 -10.5703 +3423 6 17.8651 35.1614 24.3791 -20.7499 -4.98646 -29.5673 +3424 4 18.0576 34.6235 25.1649 -8.37985 -1.7243 -11.1178 +3425 4 17.2007 34.681 23.779 26.831 10.1018 28.2803 +3426 6 49.1285 3.31358 19.7417 -8.45795 -3.91869 -17.1851 +3427 4 48.8119 4.11203 20.1653 -3.29153 9.9905 4.05996 +3428 4 49.7807 2.96094 20.3466 4.32541 -4.85853 3.16639 +3429 6 30.2844 35.6035 13.4934 7.2001 -0.317469 -2.452 +3430 4 29.4623 35.659 12.9857 1.71884 -1.71824 2.45729 +3431 4 30.0585 35.4328 14.4204 -4.00669 1.3983 -5.34585 +3432 6 43.3887 25.8808 41.6785 -22.9069 -12.3923 -2.55701 +3433 4 43.9997 25.6768 40.9817 12.0928 0.211006 -14.0269 +3434 4 43.8339 26.4255 0.397834 14.8568 14.8319 19.2759 +3435 6 21.0884 23.1529 6.38678 -1.35916 1.28851 13.8592 +3436 4 21.4 23.8645 6.98768 -5.78702 -12.5756 -9.70729 +3437 4 21.3246 23.4545 5.51028 2.40121 5.3387 -13.5131 +3438 6 54.6143 21.1989 19.0895 1.0726 18.3039 13.0104 +3439 4 0.43531 21.5582 19.5367 -15.0683 -8.68203 -12.1911 +3440 4 53.867 21.7044 19.4937 16.3508 -9.47613 -7.9193 +3441 6 13.877 38.9443 18.7624 -3.57764 -10.5141 -5.7706 +3442 4 13.4493 38.4672 19.4981 1.6116 7.10734 -3.21136 +3443 4 14.0821 39.8514 19.0249 -5.40993 2.00969 6.25434 +3444 6 39.1872 2.73234 39.6824 0.14108 0.727177 -8.14712 +3445 4 38.529 2.27328 40.2354 4.03816 -1.16808 -5.22543 +3446 4 39.0548 2.41866 38.7627 -6.48078 -0.982324 12.2661 +3447 6 43.2185 33.8148 8.84061 -19.4182 46.8926 -2.36482 +3448 4 43.1772 32.9719 9.24022 -1.50187 -35.3898 17.2737 +3449 4 42.5163 34.3616 9.29053 19.0727 -15.0644 -10.6104 +3450 6 23.089 16.6827 12.1027 15.7208 -3.2574 -7.89972 +3451 4 23.4385 16.1911 11.3228 -11.6069 8.24456 13.4993 +3452 4 22.136 16.8018 11.9813 0.424679 -1.38664 -3.29845 +3453 6 40.7855 26.1389 36.3196 -19.9126 19.309 9.87347 +3454 4 40.0986 26.8534 36.2514 19.4153 -21.5003 1.38126 +3455 4 41.1517 26.0031 35.4437 4.25962 0.995192 -8.54639 +3456 6 15.1503 11.6717 19.2973 0.724699 -1.19191 17.6918 +3457 4 15.5299 12.2877 18.6792 5.27756 8.7759 -18.41 +3458 4 15.4868 12.0294 20.1269 -4.65024 -4.08223 3.58338 +3459 6 9.86165 29.8154 31.387 -8.94942 -10.7424 5.06077 +3460 4 10.5846 30.1184 31.9716 0.245343 7.83947 -17.0155 +3461 4 9.856 30.1645 30.4637 12.8302 0.479173 21.4055 +3462 6 2.12473 30.035 25.2763 1.78753 8.3758 2.85176 +3463 4 2.08519 29.2167 25.7943 1.54705 3.16986 -12.4779 +3464 4 2.12365 29.8679 24.3136 0.147535 -6.31004 19.3474 +3465 6 49.0081 10.6471 7.05663 3.22839 15.7191 0.010386 +3466 4 49.8069 10.5015 7.59507 -11.7369 -5.9273 -2.35907 +3467 4 48.4474 9.86293 7.09337 3.15572 -10.0552 5.75386 +3468 6 38.6524 34.4248 32.4903 14.0617 12.8107 -4.97275 +3469 4 38.3124 35.2999 32.7524 2.4491 -7.54743 -1.61947 +3470 4 38.3152 33.7696 33.1015 -5.90625 -1.07654 6.02858 +3471 6 24.2925 24.7077 4.76791 -9.60212 12.423 13.627 +3472 4 24.6592 23.9059 5.14091 6.4374 -12.2494 -4.05598 +3473 4 24.0877 25.2629 5.55261 2.76703 -5.61196 -18.2913 +3474 6 44.0394 23.5955 33.7722 -22.1761 -10.7316 25.8053 +3475 4 43.54 23.0408 33.1405 14.8275 10.6039 0.934173 +3476 4 44.7909 24.0173 33.3845 18.136 8.68259 -21.6513 +3477 6 45.1404 31.9557 26.6336 7.63501 -16.8517 -19.5705 +3478 4 44.7419 32.078 27.4825 -5.98757 6.26965 19.5048 +3479 4 44.9572 31.0195 26.4087 0.928196 13.8489 4.22851 +3480 6 52.067 6.35346 22.8527 -23.4258 -19.9992 -0.226773 +3481 4 51.4359 5.65775 23.1792 22.6487 15.1416 -4.78776 +3482 4 51.473 7.11391 22.7826 5.97124 1.02094 -2.8274 +3483 6 5.11659 17.7141 30.4608 -43.6072 -14.7819 8.36724 +3484 4 5.56343 17.5578 29.6371 20.9412 3.52217 -11.7922 +3485 4 5.63141 18.2128 31.0754 22.7819 13.5036 5.79607 +3486 6 48.537 17.0137 6.52887 28.2349 12.1042 -25.3981 +3487 4 48.2628 16.1023 6.56372 -5.81913 -12.4107 2.5618 +3488 4 49.2494 17.0592 5.82246 -25.6562 2.24824 21.9849 +3489 6 13.808 31.3142 23.4689 -3.64011 -9.68131 26.3432 +3490 4 14.1349 31.2178 24.3617 -12.0329 4.75192 12.2102 +3491 4 14.6149 31.173 23.0226 30.8248 -5.26015 -34.1434 +3492 6 28.4946 33.4369 26.0285 16.4638 25.2333 -6.25798 +3493 4 28.7216 32.7387 25.4298 8.48672 -9.67688 -13.795 +3494 4 27.7897 33.0868 26.5316 -24.4903 -9.494 23.2581 +3495 6 9.0435 22.9594 11.008 21.162 0.605596 1.29652 +3496 4 9.33306 22.7779 10.1087 -4.82127 0.713158 -4.26872 +3497 4 9.8456 22.7632 11.5172 -9.5186 2.48902 2.0044 +3498 6 40.5545 4.06728 26.5809 44.6249 -53.7912 6.90123 +3499 4 40.0988 4.06982 27.4038 -17.0162 4.47424 24.8249 +3500 4 40.1579 4.71783 26.0744 -31.5116 46.4114 -32.7723 +3501 6 17.0554 37.9737 20.9489 23.2001 5.84937 -15.1211 +3502 4 17.8184 37.6206 21.4529 -18.1961 -0.773306 2.14347 +3503 4 16.241 37.9215 21.4323 -8.54619 -6.77157 16.0583 +3504 6 31.9589 6.36634 14.2007 -32.7312 -5.18635 1.31695 +3505 4 31.6173 5.45206 14.3159 2.63352 8.72785 -2.4018 +3506 4 32.9006 6.25378 14.1536 18.2531 -4.45925 -0.605861 +3507 6 29.3682 34.9487 39.6588 1.61784 2.82525 -17.5597 +3508 4 29.3689 34.7576 40.5935 -6.77547 -0.101859 12.4897 +3509 4 28.4273 35.0463 39.4168 8.43037 -3.37269 4.33216 +3510 6 22.5699 2.93494 32.1141 -1.63629 -8.86743 4.25418 +3511 4 23.0898 3.67063 31.7669 1.49018 1.71101 -1.29845 +3512 4 22.818 2.15292 31.5827 -1.92581 11.5593 5.09528 +3513 6 51.7444 19.0899 24.8018 18.5566 14.3159 27.8709 +3514 4 52.1262 19.3991 25.6728 -16.855 -8.06891 -29.5747 +3515 4 52.1578 19.634 24.1129 -3.61196 1.33098 2.20453 +3516 6 32.1137 13.664 24.2226 6.2567 1.72658 -37.8727 +3517 4 32.2307 13.7857 25.1378 6.97488 6.10606 45.7276 +3518 4 31.1794 13.5551 24.0935 -22.8325 -3.39176 -1.92521 +3519 6 9.48788 30.1788 28.8037 -7.90151 -0.480281 -10.0021 +3520 4 9.04214 29.3907 28.4657 0.296662 -4.58444 4.12418 +3521 4 9.71381 30.648 27.9899 1.85323 2.91474 4.33114 +3522 6 31.3027 3.12343 24.087 3.70677 4.08208 -3.18372 +3523 4 30.8363 3.94541 23.9161 -7.21645 -1.79011 2.75115 +3524 4 32.1629 3.26377 23.6687 3.35255 -5.74571 3.4439 +3525 6 2.14326 19.8385 36.4613 43.5578 -10.0216 -16.9659 +3526 4 3.05142 19.7594 36.0352 -31.8637 8.98539 19.2185 +3527 4 1.69253 19.0555 36.1346 -14.6763 0.545221 1.96285 +3528 6 36.957 16.7591 14.0918 2.96563 -13.2358 -6.51153 +3529 4 37.0513 17.1687 14.9682 1.23982 -3.45998 -2.6752 +3530 4 37.3406 15.8552 14.1067 -4.20166 12.9403 2.86695 +3531 6 1.82327 11.1921 6.0808 -0.275886 9.47834 -4.04825 +3532 4 1.66503 10.3513 6.51275 0.636708 -7.94921 -0.277572 +3533 4 1.41092 11.8149 6.68093 -3.53423 6.76721 2.7814 +3534 6 43.1526 36.8455 25.2619 -8.14588 -11.3328 3.19442 +3535 4 42.3648 36.774 24.6888 4.17675 -0.750929 11.0286 +3536 4 43.0263 36.2034 25.9927 3.18182 11.8936 -13.2388 +3537 6 32.1279 5.54767 7.01242 2.49094 2.37791 -5.83138 +3538 4 31.9279 4.68363 7.38152 0.218816 -4.41428 4.71371 +3539 4 31.563 6.18782 7.45455 -6.02642 2.24751 5.27561 +3540 6 15.066 21.4965 41.5173 26.6113 -14.2353 0.879596 +3541 4 14.4098 21.4318 0.299313 -13.8163 5.2854 1.00244 +3542 4 14.7314 21.9782 40.7628 -14.3918 6.6959 -6.38566 +3543 6 37.0263 36.0654 5.67599 -8.66989 11.0394 5.08886 +3544 4 36.7926 36.9074 5.26668 1.42879 3.21556 -9.50708 +3545 4 36.6993 36.1724 6.58455 6.67811 -8.44617 -2.15326 +3546 6 39.6264 22.8802 0.345968 -6.61229 0.0560669 1.87747 +3547 4 39.9979 23.7083 41.9266 1.97423 1.58642 1.0556 +3548 4 39.8106 22.8717 1.30105 -0.716498 -2.72173 1.5866 +3549 6 18.4762 23.1875 5.24196 -3.43754 -16.0644 -0.1002 +3550 4 18.2109 24.0785 4.97873 9.26343 12.8459 2.1419 +3551 4 19.3202 23.1705 5.73113 -5.23082 11.7415 -3.58503 +3552 6 34.4866 26.3931 0.410981 -26.1443 -19.9516 50.1306 +3553 4 33.9706 27.0567 0.94736 13.8106 -10.3269 -20.7381 +3554 4 34.4077 25.5868 1.01915 10.7474 25.1704 -28.4611 +3555 6 28.1474 26.0925 40.6196 -28.5345 -18.6936 36.4955 +3556 4 29.0529 26.0026 40.9247 9.18224 2.32741 -2.79367 +3557 4 27.6107 25.644 41.3519 15.6172 17.8969 -31.6189 +3558 6 41.7482 4.39863 30.2421 -5.41295 4.8086 27.4354 +3559 4 42.5847 3.93131 30.2216 8.80522 -6.59194 -7.61494 +3560 4 41.6924 4.68152 31.1831 -5.94926 -0.146025 -12.4776 +3561 6 4.45598 8.30655 29.1222 20.5127 -16.5965 8.52389 +3562 4 3.66946 8.7156 28.7677 -9.60933 13.4518 -0.978151 +3563 4 4.96147 8.97819 29.6123 -10.8114 0.933443 -7.64816 +3564 6 12.9096 9.61234 32.1411 7.95239 -11.3181 7.67023 +3565 4 12.5174 8.82681 31.7782 -9.40951 -4.97415 -8.25208 +3566 4 13.381 9.26623 32.9076 3.83436 11.6436 3.42456 +3567 6 48.6608 16.2478 1.44826 -41.5847 5.12436 -2.24268 +3568 4 49.5977 16.2655 1.51923 27.6715 2.95254 13.2549 +3569 4 48.2356 16.5221 2.2956 18.9339 -8.30142 -14.6437 +3570 6 26.4307 40.0076 21.1903 -9.81311 41.2665 6.04236 +3571 4 27.1749 40.6498 21.1967 -8.04845 -12.0635 0.822588 +3572 4 26.7755 39.1508 21.0026 13.0624 -20.4442 -2.17563 +3573 6 35.79 4.08177 9.00682 -31.6066 0.334495 -4.41207 +3574 4 35.483 4.74976 8.36033 1.0784 -4.66377 5.72074 +3575 4 35.0087 3.86601 9.59196 22.2264 5.21899 -16.6494 +3576 6 52.6895 3.55332 27.8634 16.2443 -8.90238 -17.7273 +3577 4 53.4861 3.5089 28.4695 -19.2533 -5.0216 -23.8454 +3578 4 52.9436 3.34738 26.8904 -3.28408 11.0051 45.9059 +3579 6 48.3169 26.6974 27.3926 25.9077 -23.6746 5.28014 +3580 4 49.0048 25.9927 27.5456 -25.7263 19.495 -6.18754 +3581 4 48.6886 27.4598 27.8411 -2.12981 11.4596 4.51315 +3582 6 24.5097 4.95686 18.7286 -11.1396 -9.34012 13.2359 +3583 4 24.0942 4.18073 19.1756 8.31772 16.1923 -9.35863 +3584 4 23.9484 5.73893 18.8892 6.66511 -10.1227 -0.689949 +3585 6 24.0567 12.4804 28.7686 -1.83015 0.889486 -1.95598 +3586 4 23.1997 12.8888 28.9043 -2.54864 9.49841 4.61676 +3587 4 23.8244 11.6446 28.3683 7.90245 -6.62953 -5.67748 +3588 6 40.1561 27.7426 40.8073 -21.5317 7.14576 -7.35733 +3589 4 40.4932 26.962 41.2601 -12.917 0.0491148 -0.726507 +3590 4 39.1936 27.5721 40.6401 25.9681 1.33069 1.19471 +3591 6 11.9274 13.5458 26.9496 -4.40765 -1.96337 -6.60028 +3592 4 10.9986 13.6678 27.167 -4.51497 -1.32563 0.190923 +3593 4 12.2404 12.8654 27.5442 6.31176 -11.0874 3.59056 +3594 6 52.1902 29.5387 41.394 18.594 -11.3781 3.59259 +3595 4 51.989 30.3087 0.0068425 -9.85392 15.5397 4.91192 +3596 4 53.1003 29.3208 41.6912 -5.64389 -6.04423 -8.59676 +3597 6 17.4867 19.0227 39.1838 -6.27455 21.666 2.75279 +3598 4 17.488 19.586 40.0024 0.860103 -14.9947 -21.9977 +3599 4 17.2876 19.5951 38.4014 5.36511 -12.0476 21.2649 +3600 6 46.2283 27.6807 33.7144 -6.74129 13.676 11.5468 +3601 4 46.0876 28.3582 33.0447 4.86435 -1.49715 -10.0026 +3602 4 45.6533 27.9743 34.4365 0.457797 -3.70748 6.99028 +3603 6 35.8353 29.5439 5.61992 2.49906 -1.59566 -19.7219 +3604 4 35.6527 29.5233 4.66367 4.90114 -0.621078 3.19465 +3605 4 35.4473 30.3766 5.88547 -3.82587 11.7884 10.6864 +3606 6 47.2822 25.7798 30.1513 -10.5766 8.53329 -17.9568 +3607 4 48.1664 25.813 29.7363 -13.2628 3.84456 1.19765 +3608 4 46.6616 26.387 29.6551 21.0058 -12.1546 6.47151 +3609 6 51.3953 12.3638 20.0228 -1.62023 8.46277 -4.73872 +3610 4 50.7529 12.7462 19.4094 4.65296 3.97806 -1.37635 +3611 4 50.8736 11.6867 20.4477 2.10356 -10.8225 11.04 +3612 6 41.9857 18.3757 28.9464 12.9674 -8.39178 -20.9845 +3613 4 42.6678 18.0249 28.3214 -8.5661 8.58724 12.8041 +3614 4 42.4509 18.9846 29.5329 1.95722 -2.13958 -2.01301 +3615 6 53.5955 6.47736 7.49747 -17.4879 -34.0434 -11.6994 +3616 4 53.215 5.56736 7.34717 12.2612 27.0176 1.32153 +3617 4 53.8473 6.47025 8.42428 8.27981 0.813073 3.28926 +3618 6 9.90701 10.6092 26.7593 2.25524 -7.80823 -0.160956 +3619 4 10.2937 10.2906 27.6083 -8.74192 13.2514 -11.8083 +3620 4 9.6719 11.5504 26.8324 5.3909 -8.28719 7.73453 +3621 6 9.32838 39.4044 29.7661 28.1478 19.087 17.9947 +3622 4 10.1636 39.3682 30.3277 -29.6144 2.71186 -18.0569 +3623 4 8.79772 40.1574 30.1092 9.7156 -13.1012 -9.05156 +3624 6 33.3969 4.77935 0.0338577 7.04977 -8.48101 -1.75146 +3625 4 33.7652 5.5373 41.4968 -3.54645 16.0087 -2.35532 +3626 4 34.1271 4.15493 41.8774 -6.76144 -3.49152 6.70786 +3627 6 35.7118 10.6691 34.2465 30.5451 -20.2214 -10.6481 +3628 4 35.199 10.7815 35.0349 -14.696 6.44481 20.012 +3629 4 36.4515 10.0721 34.5187 -16.7263 14.6249 -6.06398 +3630 6 15.1941 17.3851 19.1797 2.70911 -28.1342 -44 +3631 4 15.4897 16.9339 18.3047 -12.3876 19.7973 41.7399 +3632 4 14.2542 17.5546 19.0074 0.407714 2.19657 2.29796 +3633 6 17.478 37.6645 15.4329 -18.9254 1.45878 17.8737 +3634 4 16.9549 37.8023 16.2867 26.4617 -7.60783 -22.0624 +3635 4 18.4074 37.4659 15.6333 -6.79317 3.25497 7.31584 +3636 6 26.2497 8.20945 21.7084 13.406 8.66037 11.1677 +3637 4 26.4123 8.51714 22.643 -13.4745 -7.28424 -22.9055 +3638 4 25.3027 8.1176 21.5293 -5.49097 3.27453 10.4234 +3639 6 0.34 9.90937 15.4047 -28.932 15.8312 -5.67551 +3640 4 1.21626 9.57115 15.2747 8.47529 -16.8828 -5.88536 +3641 4 54.6903 9.41637 14.8207 22.8064 6.49071 10.4803 +3642 6 13.4564 40.6532 9.29599 -22.1307 -5.15585 -0.326819 +3643 4 12.4714 40.4452 9.30279 34.033 7.20134 3.90171 +3644 4 13.9359 39.9749 9.79874 -9.44555 -0.536228 -2.64909 +3645 6 49.5525 25.9167 33.0087 8.30289 -20.978 36.7812 +3646 4 50.1102 25.581 33.7998 -31.2394 16.5759 -41.6702 +3647 4 48.6381 25.5592 33.0807 18.1841 3.33668 -0.378289 +3648 6 37.0921 40.0433 26.4323 -69.9693 32.9093 31.9949 +3649 4 36.1848 39.6472 26.7001 50.2617 0.87061 -16.3943 +3650 4 36.887 40.9984 26.66 23.4133 -30.5831 -16.8038 +3651 6 47.9876 17.8592 12.1588 -8.21233 14.3088 -32.1086 +3652 4 47.5845 18.6288 11.6747 8.44083 -19.6159 16.8154 +3653 4 47.7143 17.8826 13.0665 -7.39134 3.08395 19.3289 +3654 6 27.9663 29.0642 34.1603 1.53587 -18.0299 -1.74725 +3655 4 28.882 28.804 34.3498 -7.37789 1.41773 -2.30399 +3656 4 27.9529 30.0159 34.1809 1.22694 21.8088 1.61581 +3657 6 34.0029 2.78452 13.2168 -24.1529 16.185 8.10865 +3658 4 33.6393 2.32953 13.9926 -4.91269 2.52718 -2.68734 +3659 4 34.7844 2.29731 13.0428 30.2788 -14.7346 -8.06408 +3660 6 28.44 36.053 11.4482 -19.9886 -0.916941 20.5685 +3661 4 28.0041 35.3416 10.9605 0.296796 1.69001 -2.92558 +3662 4 29.0597 36.4216 10.8465 18.9417 8.99323 -20.1084 +3663 6 36.1834 11.364 28.8528 2.80179 -1.8504 -16.6465 +3664 4 35.2026 11.3648 28.9433 17.0081 -1.44193 -10.527 +3665 4 36.4266 11.2403 27.8881 -16.5332 2.0664 24.3605 +3666 6 24.8155 39.488 16.899 1.95651 8.69094 -17.2938 +3667 4 24.2729 40.277 17.0547 2.68209 -2.76325 7.28198 +3668 4 24.7648 39.3887 15.9322 -0.898649 -0.731043 6.96785 +3669 6 49.9432 8.0514 22.8505 -60.8038 -24.1516 -13.0827 +3670 4 49.7668 7.94962 23.7845 10.2147 3.57848 16.1239 +3671 4 49.0378 7.75433 22.5026 41.2245 11.1916 1.13457 +3672 6 52.0935 19.338 10.2277 12.6357 -4.19253 18.0692 +3673 4 51.6063 19.2592 9.39778 1.74616 10.4418 -3.52762 +3674 4 52.4735 20.2434 10.294 -12.5007 -15.5081 -12.5544 +3675 6 24.8386 15.8838 6.12895 -18.3448 14.0073 -0.236232 +3676 4 24.2024 16.3229 6.74681 14.2411 -11.6767 -8.77744 +3677 4 24.4989 16.1625 5.25788 7.11766 -3.93298 6.13727 +3678 6 49.3148 23.6851 8.6303 24.9689 -39.379 16.691 +3679 4 49.2746 22.9584 9.31909 -7.63259 29.9964 -23.4819 +3680 4 48.4638 24.0489 8.3953 -15.5352 0.433996 3.53825 +3681 6 0.208059 10.6481 32.1797 22.1875 -2.28391 4.69689 +3682 4 1.08388 10.2912 32.3483 11.827 -2.86298 -20.6213 +3683 4 54.878 10.581 33.0649 -30.4469 3.74284 18.7822 +3684 6 12.5874 32.9143 13.2407 -35.4131 4.94433 4.95913 +3685 4 11.7345 33.4182 13.1185 22.1299 -14.9844 2.19911 +3686 4 13.2795 33.4792 12.9271 13.1216 10.0242 -5.44208 +3687 6 21.734 32.5657 14.1089 -30.2641 -10.609 17.8788 +3688 4 21.1735 33.3586 14.1938 13.4775 0.171544 -7.80997 +3689 4 21.2373 31.9121 14.6504 18.4585 12.3126 -12.4653 +3690 6 48.1656 34.8484 27.3207 -34.4178 -12.3509 -32.6658 +3691 4 47.5287 35.1179 27.9926 9.598 2.53078 9.45385 +3692 4 47.5616 34.4813 26.6056 29.2581 12.2879 19.461 +3693 6 45.6153 31.2627 36.0943 -37.261 16.4569 21.0579 +3694 4 45.7916 31.8927 35.3904 -0.807743 4.61331 -8.81752 +3695 4 44.8366 31.6277 36.6156 19.759 -7.25665 -17.1647 +3696 6 46.2873 0.296503 14.3622 0.346279 -8.22198 0.0964187 +3697 4 46.2502 1.23933 14.2464 -13.6881 13.1616 4.37405 +3698 4 47.2018 42.0236 14.1712 14.709 -12.2876 -2.23521 +3699 6 14.3299 18.994 40.2006 -30.7379 -32.6603 -9.06287 +3700 4 14.4791 19.2338 39.2972 7.93482 8.11578 -14.4624 +3701 4 14.6855 19.6458 40.7662 17.9566 28.0241 18.1173 +3702 6 14.5596 1.14026 10.2341 26.3279 -2.23148 -9.5451 +3703 4 15.4055 1.22344 9.73443 -17.3894 7.51472 10.761 +3704 4 14.1379 0.381418 9.8097 -7.55267 -3.97863 3.86231 +3705 6 34.4334 40.9199 12.9894 -0.940803 4.29697 -17.7271 +3706 4 34.039 40.5607 12.1545 5.82782 2.6847 22.9711 +3707 4 34.273 40.3011 13.7266 -2.01031 0.481385 -16.696 +3708 6 42.1477 25.6267 33.9881 24.0417 -24.4569 -2.75436 +3709 4 41.6299 25.3559 33.2134 -0.0206438 0.202706 6.41118 +3710 4 42.855 24.9213 34.0976 -22.0628 21.5276 -5.85955 +3711 6 29.1852 22.5895 40.0737 -4.6165 -6.65381 -10.571 +3712 4 28.5947 23.1672 39.581 -0.582997 4.41945 3.85107 +3713 4 29.0675 22.7332 41.0074 -2.93269 3.94269 10.2267 +3714 6 44.8062 18.6252 1.49818 5.72139 3.58279 15.6322 +3715 4 44.9314 18.8801 2.44529 -3.9019 -2.65234 -18.9387 +3716 4 44.0985 19.1782 1.14518 3.29812 2.13948 3.69359 +3717 6 4.47265 10.8135 23.9407 -24.2902 -18.4562 11.3409 +3718 4 5.11906 11.4142 23.6391 22.3407 21.5355 -19.7447 +3719 4 4.51291 10.8829 24.8932 -6.80118 0.381125 6.4492 +3720 6 6.46087 23.0097 28.9948 -0.180046 29.3158 3.74757 +3721 4 7.16357 23.1777 29.6697 -12.977 -15.1924 -17.9731 +3722 4 6.42476 22.0762 28.8013 7.623 -17.0728 6.50296 +3723 6 39.796 25.1427 32.5747 9.70804 -1.04373 -32.2987 +3724 4 39.5377 25.4516 33.4106 -12.9416 11.3784 38.6909 +3725 4 39.6539 25.9218 32.0211 1.09764 -5.16827 -8.54386 +3726 6 40.8629 21.4836 8.86543 0.741147 13.6451 -7.24725 +3727 4 40.6441 21.3431 7.92826 2.29745 -6.5969 8.98303 +3728 4 41.3236 20.7041 9.20266 3.81714 -8.25026 -3.81722 +3729 6 0.635293 1.4289 12.9408 -11.8573 10.3167 -17.0811 +3730 4 54.7874 1.76314 12.6159 9.08744 8.74788 -10.2417 +3731 4 0.270536 0.805051 13.547 10.8795 -21.9384 23.5147 +3732 6 32.6734 29.7199 23.4842 -6.31159 -22.9731 3.95312 +3733 4 32.3164 28.805 23.472 7.37478 14.3791 4.20759 +3734 4 32.5291 29.9779 22.5736 0.738758 10.2783 -10.1223 +3735 6 12.5322 37.1564 20.4866 30.6876 51.3804 29.6269 +3736 4 13.0449 37.1468 21.3313 -10.4644 -1.04639 -16.0138 +3737 4 12.1935 36.3015 20.3752 -17.5174 -49.5479 -6.43685 +3738 6 13.879 14.5208 24.6979 -2.0089 -0.488943 14.0828 +3739 4 13.5126 15.2415 24.1863 -2.86121 7.01781 -5.24136 +3740 4 14.0435 14.8889 25.5812 -0.885703 0.504049 -6.33424 +3741 6 17.5084 27.0547 26.4789 25.7109 3.2743 -38.4356 +3742 4 17.3703 27.9297 26.0618 -4.07905 -12.769 13.7294 +3743 4 18.1097 26.6273 25.8042 -17.4354 5.34049 24.3014 +3744 6 54.4807 9.52867 26.3526 -8.08409 11.5192 21.059 +3745 4 54.0543 10.3952 26.5681 7.59002 -15.9534 -5.94965 +3746 4 54.8701 9.18952 27.1901 -5.85154 7.09102 -14.0848 +3747 6 33.6811 21.5047 24.9231 9.13792 -2.03882 -43.3211 +3748 4 33.6373 21.3676 23.9235 3.71376 4.25849 32.7793 +3749 4 32.846 21.1613 25.2346 -13.4677 -6.75943 10.2286 +3750 6 22.147 35.267 2.89295 -1.50127 3.24452 17.3348 +3751 4 22.2381 34.4 2.47628 0.948748 -2.82555 0.0189077 +3752 4 22.0999 35.1233 3.8735 0.523717 -2.91888 -18.7193 +3753 6 45.3111 5.3951 15.6139 -0.0233827 -18.9082 29.3701 +3754 4 45.1442 5.22798 16.5663 9.63366 2.6406 -14.7931 +3755 4 44.5125 5.84005 15.3428 -8.81534 4.22624 -14.6387 +3756 6 5.67663 7.59044 16.9735 -0.040306 4.08799 -12.5895 +3757 4 5.28026 7.88599 16.128 7.47401 -1.2917 10.5251 +3758 4 6.58383 7.937 17.01 -0.793937 -3.87211 -2.68331 +3759 6 34.58 39.0977 27.2045 1.42769 14.436 -3.31523 +3760 4 34.2907 38.4975 27.863 -0.77861 -26.0942 16.6839 +3761 4 34.0642 39.8725 27.4397 -1.42861 13.6713 -5.6929 +3762 6 32.7657 33.6085 34.293 -22.4583 20.5671 -18.6673 +3763 4 32.1806 34.0441 33.6111 23.9751 -17.2665 15.818 +3764 4 32.4638 34.0082 35.1245 2.30326 -6.42306 -1.86009 +3765 6 30.988 41.2133 32.384 -4.02481 -7.82035 -3.95856 +3766 4 30.2267 41.2202 32.9774 -4.32902 6.50081 -0.328838 +3767 4 31.0509 0.17511 32 -1.2051 10.1503 -2.92525 +3768 6 7.6493 1.59177 27.1464 22.3535 -22.6118 -16.4669 +3769 4 8.41104 1.29664 26.5499 -29.8997 15.2665 16.3611 +3770 4 7.54328 2.53873 27.061 4.65755 9.49162 -4.22239 +3771 6 0.888965 22.101 37.8501 15.4112 -23.8094 -16.9331 +3772 4 1.26739 21.3109 37.3638 -11.0686 24.0488 15.8162 +3773 4 1.18 22.8712 37.3372 -1.61814 -2.27923 2.93708 +3774 6 7.39632 11.121 19.2332 -2.86932 4.41375 3.62624 +3775 4 7.58751 12.0436 19.3904 -7.23274 18.3647 6.41875 +3776 4 8.29083 10.7877 19.1848 5.97481 -12.1861 -3.76707 +3777 6 43.7816 12.5054 37.3126 2.86093 2.78929 -1.28281 +3778 4 43.9727 12.4749 36.3586 -3.06612 0.785718 5.83621 +3779 4 44.6572 12.6706 37.7021 -4.14278 -2.20963 -1.61523 +3780 6 29.0947 33.5132 36.1777 7.61955 17.1376 -26.1106 +3781 4 29.8261 34.0815 35.8667 -13.5031 -6.20718 4.51186 +3782 4 29.4784 33.1216 36.9462 10.9925 -12.9866 20.6523 +3783 6 14.807 4.60084 3.93512 20.0881 9.19657 -13.3363 +3784 4 14.316 4.04064 3.33426 -13.0632 -7.60853 1.79497 +3785 4 15.6236 4.79338 3.42413 -10.111 -0.253003 10.8348 +3786 6 39.0437 6.41097 6.40143 -11.952 4.4329 11.9095 +3787 4 39.4604 7.16771 6.02322 8.12547 27.0605 -0.357881 +3788 4 39.3566 5.75952 5.7919 -0.567413 -21.3616 -5.48613 +3789 6 22.2146 37.9992 40.767 -9.02066 -17.4896 -19.1754 +3790 4 22.494 38.8839 40.5618 6.85259 22.4587 -5.93601 +3791 4 22.4583 37.8811 41.6743 4.99519 -4.33654 23.0463 +3792 6 4.4524 23.286 6.15211 29.8095 -7.21279 -13.1375 +3793 4 3.81791 23.938 6.45512 -14.4589 -6.71938 9.72163 +3794 4 4.31449 22.3781 6.49744 -8.68344 13.1635 4.00749 +3795 6 12.4271 23.7748 9.24631 -1.26755 4.43152 21.3749 +3796 4 11.5607 23.6235 8.88266 -11.7175 -2.77193 -9.11925 +3797 4 12.2509 24.3149 10.0432 11.3809 -1.60307 -13.9136 +3798 6 46.4989 15.2625 16.9679 -12.8481 -2.49131 10.8408 +3799 4 47.085 14.9252 16.2779 8.49272 6.07271 -3.86524 +3800 4 46.8927 16.0486 17.3753 9.61298 -1.72862 -3.23202 +3801 6 34.1182 27.164 19.7815 17.9289 -11.392 6.58771 +3802 4 34.8637 26.5005 19.7508 -17.7467 14.3364 5.12367 +3803 4 34.0077 27.4664 20.702 3.31322 -6.80894 -12.4792 +3804 6 46.9518 13.2225 35.1059 11.5726 -0.299351 34.0182 +3805 4 47.3951 14.0533 34.9197 -1.30218 2.22738 -12.772 +3806 4 46.5273 12.8898 34.3328 -6.46075 0.0352155 -21.0879 +3807 6 50.5846 18.7905 12.5321 0.161349 -2.47544 -10.5355 +3808 4 49.7474 18.3698 12.2516 10.3296 3.30344 0.704295 +3809 4 51.1853 18.7954 11.7538 -11.6392 0.795373 7.80699 +3810 6 32.4849 12.6316 31.9547 13.623 -32.1984 -17.1952 +3811 4 32.7548 11.6805 31.9646 -3.77817 17.5545 -6.43374 +3812 4 32.3724 12.7906 32.8759 -7.39939 11.2146 27.5789 +3813 6 6.21204 19.6856 10.0139 6.84548 18.8235 13.1049 +3814 4 6.54027 20.2383 9.28123 0.761161 -1.37122 2.72757 +3815 4 6.08461 20.3138 10.7689 1.69871 -13.3343 -16.4193 +3816 6 21.5267 21.5372 2.4283 -5.72751 11.2346 -5.82425 +3817 4 21.7624 21.5115 1.48057 4.80944 -6.6677 9.03128 +3818 4 21.9699 20.8013 2.88237 1.68469 2.19074 -10.3234 +3819 6 38.389 23.0803 17.19 -15.8009 11.2489 14.8144 +3820 4 38.843 23.3405 16.3672 7.30113 -17.2523 7.40945 +3821 4 38.5581 22.1678 17.4979 8.57434 6.38113 -15.3203 +3822 6 29.7009 24.9705 22.2505 40.9979 -45.9373 -29.6811 +3823 4 30.2007 24.9541 23.0531 3.51493 7.58579 28.6285 +3824 4 28.9709 25.5198 22.3387 -45.941 40.092 17.1582 +3825 6 30.3026 21.4444 37.7784 -57.0222 17.1687 -23.3742 +3826 4 30.3615 21.3347 36.805 9.38026 -2.23221 21.4717 +3827 4 29.3011 21.6413 37.9016 49.3444 -12.8915 1.59191 +3828 6 11.8723 11.7062 16.3108 -33.4349 -15.0686 -41.1118 +3829 4 11.3207 12.2631 16.8681 -3.98396 2.02201 -1.40695 +3830 4 11.3108 11.5232 15.4705 24.8968 9.48818 41.0096 +3831 6 5.70652 16.9717 10.4705 4.17204 -12.2255 5.26049 +3832 4 4.89872 17.0293 11.0039 1.44556 1.21447 -8.81597 +3833 4 5.85075 17.8293 10.0626 -3.65007 4.58518 2.58079 +3834 6 41.6977 34.1692 35.8837 -2.16171 7.35997 35.3278 +3835 4 41.9434 35.0359 36.2767 -7.39108 -12.3774 -11.2945 +3836 4 41.6554 34.2509 34.9408 0.248654 6.88642 -24.6778 +3837 6 33.755 1.15956 30.1148 26.9661 -5.30311 0.785489 +3838 4 32.8327 1.41064 30.2749 5.35845 -2.81639 19.5818 +3839 4 34.3082 0.981132 30.9387 -30.8845 7.54253 -18.2089 +3840 6 50.3537 18.6141 36.9811 22.0078 18.2711 -1.17075 +3841 4 50.0553 18.9081 37.8421 -3.0234 4.11827 7.26126 +3842 4 49.7241 17.9789 36.6994 -26.7065 -28.1871 -12.5747 +3843 6 24.6713 24.2747 40.2422 -22.5478 13.5437 8.83718 +3844 4 23.7682 24.4281 40.6159 16.469 -5.34198 -8.29501 +3845 4 24.8078 23.3187 40.2616 -1.76472 2.5507 -0.358513 +3846 6 37.3089 22.0315 23.2412 -5.67505 16.6134 8.34505 +3847 4 36.9227 21.8066 24.1113 8.4343 -8.15598 -10.5545 +3848 4 37.8295 21.3076 22.8826 1.63944 -5.88141 4.04288 +3849 6 48.4175 40.505 28.9613 -8.44239 17.3351 -31.8351 +3850 4 48.9168 41.2502 28.5701 -3.67522 -6.90368 3.5913 +3851 4 47.6498 40.4225 28.3398 9.75729 -4.39015 14.633 +3852 6 24.8456 8.73476 16.5822 -4.20971 0.107082 12.7896 +3853 4 25.4166 9.33437 17.0882 0.801486 -3.84637 -6.6671 +3854 4 25.3552 7.93888 16.3774 1.47583 -1.66023 -1.71228 +3855 6 19.2415 22.9983 32.4591 18.0731 -7.21062 -7.32059 +3856 4 18.4972 23.4837 32.0941 -3.55414 -1.2008 3.19393 +3857 4 18.9283 22.447 33.1757 -6.31405 0.951806 3.86493 +3858 6 3.33315 21.6719 22.4471 -31.3651 -15.1442 10.7623 +3859 4 2.72119 22.0562 23.134 20.4737 -7.45649 -18.1084 +3860 4 4.09369 22.238 22.38 14.9219 12.7334 2.89238 +3861 6 10.2287 20.327 12.827 -13.2346 -13.5387 -5.73443 +3862 4 9.59835 20.9044 13.2794 3.30523 -1.6991 -3.3419 +3863 4 9.66163 19.6709 12.3619 8.96671 11.3846 7.22783 +3864 6 9.52445 0.665703 25.3447 51.6699 36.9138 -22.1471 +3865 4 10.407 0.70007 25.8038 -28.3091 -11.588 2.11711 +3866 4 9.73816 1.30323 24.5834 -23.5062 -26.9191 23.3279 +3867 6 10.6629 40.7098 9.64162 -13.7092 -10.0604 -17.7529 +3868 4 10.6663 41.3337 10.3633 -2.25222 9.44489 9.13119 +3869 4 9.9177 40.9644 9.04966 14.1089 -1.91013 12.7496 +3870 6 46.3583 25.2138 32.6818 -7.00173 28.401 24.5039 +3871 4 46.1658 26.0815 33.1748 9.63216 -40.3762 -24.4036 +3872 4 46.6683 25.4845 31.8081 -0.340565 -0.626762 -0.366217 +3873 6 38.9398 3.19835 23.1062 35.7507 -3.98021 4.80576 +3874 4 38.0789 3.42388 22.7807 -21.691 0.0477325 0.592254 +3875 4 38.9606 2.6551 23.9199 -14.9585 3.95725 -7.0779 +3876 6 33.3518 23.6324 36.8776 -10.909 11.1506 22.2396 +3877 4 32.7475 23.7189 37.6717 16.9933 -10.7727 -23.1962 +3878 4 33.5054 24.5617 36.6454 5.48307 -3.56245 -8.14833 +3879 6 51.9403 33.327 25.4307 18.0164 46.0043 -41.5452 +3880 4 51.481 33.1217 26.2288 -14.6019 -1.8433 25.1586 +3881 4 51.8744 34.3335 25.2555 2.07578 -44.1738 12.4077 +3882 6 32.1773 25.016 33.1611 -3.65323 12.5958 -4.40686 +3883 4 32.7417 25.8243 33.1248 -13.2213 -13.5953 2.20315 +3884 4 31.2567 25.3353 32.9959 15.6883 -4.24783 1.324 +3885 6 51.2804 27.7082 39.5058 -12.4055 -13.8576 13.4454 +3886 4 51.6333 27.8214 38.6405 7.56348 -1.28822 -27.9214 +3887 4 51.668 28.4332 39.9759 4.38661 13.1583 16.7532 +3888 6 34.2776 28.325 17.2612 18.5433 -9.6807 0.726105 +3889 4 33.4618 28.7621 17.0499 -21.6526 10.7978 2.5619 +3890 4 34.2928 28.1986 18.2187 -4.64072 -2.98555 4.57564 +3891 6 36.914 8.0422 37.8636 -11.4128 -16.3489 28.1347 +3892 4 37.1972 8.46051 37.0352 12.2245 9.0272 12.2411 +3893 4 37.2151 8.41454 38.7513 -7.64029 -1.69915 -40.4466 +3894 6 34.8876 19.4054 6.12727 15.6033 7.52257 2.15709 +3895 4 34.0531 18.9355 6.15655 -6.74313 -1.04378 -1.75599 +3896 4 34.6977 20.3552 6.00766 0.606543 -4.24654 -1.2187 +3897 6 52.9513 9.46866 7.83406 2.51792 52.5995 -46.1577 +3898 4 52.8182 10.1965 7.1313 21.8169 -33.4663 26.408 +3899 4 52.1097 9.49548 8.25498 -20.9439 -11.3984 23.93 +3900 6 36.2784 5.48477 38.9735 -18.6298 -4.41122 2.56352 +3901 4 36.9459 5.47799 39.6359 15.3203 -14.8264 18.8091 +3902 4 36.5882 6.23606 38.5023 -2.18903 24.2959 -30.3279 +3903 6 10.0091 14.4595 13.4727 4.14065 20.8003 14.1725 +3904 4 10.1735 15.3719 13.8184 -7.35802 -17.2864 -8.75733 +3905 4 9.20522 14.5177 12.9398 -1.57173 0.82324 -0.279823 +3906 6 17.2166 24.3595 39.7866 10.3316 -24.6644 9.74438 +3907 4 16.8461 25.2181 39.6219 -11.8102 15.8188 2.99696 +3908 4 16.9967 24.0978 40.7081 2.51259 6.67153 -9.86646 +3909 6 49.0842 32.5535 7.76087 3.66191 -12.3496 8.85055 +3910 4 48.2705 33.0417 7.89853 -4.87459 2.09702 3.01394 +3911 4 49.5463 32.9698 7.04629 8.35168 7.01386 -14.6239 +3912 6 44.8849 24.3899 5.46806 25.9844 8.68062 13.8603 +3913 4 44.662 24.5947 6.37974 6.74107 7.22813 10.7323 +3914 4 44.0754 24.0079 5.20592 -32.7636 -20.0017 -25.3594 +3915 6 37.3054 29.188 32.8461 11.1431 -5.59449 16.1726 +3916 4 36.8523 29.4202 33.6742 6.83247 1.44061 -4.51415 +3917 4 36.6742 29.3068 32.1579 -22.7291 3.94299 -14.9304 +3918 6 0.907991 24.8221 21.2346 15.0832 19.7352 -4.57067 +3919 4 1.06453 25.2816 20.3717 -1.39622 -8.03116 21.3543 +3920 4 1.45755 25.2897 21.9154 -11.7661 -11.1398 -13.6241 +3921 6 53.0192 2.206 13.0014 -0.818186 11.5483 2.08343 +3922 4 52.7824 1.81345 13.8314 -6.90556 -15.4066 8.50991 +3923 4 53.4537 3.0128 13.31 2.83183 5.68595 -7.528 +3924 6 24.3052 33.9756 13.9324 20.4312 -11.5489 10.0229 +3925 4 23.7773 33.1726 14.1229 5.8111 10.1191 -2.33499 +3926 4 25.2169 33.8698 14.327 -30.0349 3.28274 -10.0023 +3927 6 40.9302 19.2912 0.318024 -15.3988 27.4065 1.86032 +3928 4 41.1581 18.3902 0.297675 9.36546 -44.4479 -0.119704 +3929 4 41.7646 19.7516 0.396104 7.20249 9.57203 1.55489 +3930 6 38.311 32.026 21.5914 -16.5672 24.1097 -12.7773 +3931 4 37.7777 31.3762 21.1012 4.07846 0.69211 1.97712 +3932 4 37.9765 32.9287 21.3171 8.34414 -28.994 10.9395 +3933 6 42.3062 34.9979 16.9676 -25.16 18.3345 5.87282 +3934 4 41.5364 35.0784 17.5803 19.0968 -0.611651 -8.13832 +3935 4 42.7061 34.1505 17.1117 7.13758 -14.417 1.0169 +3936 6 19.559 24.3289 21.9471 -10.3882 -39.985 28.3228 +3937 4 19.0651 23.5074 22.2416 22.0177 25.9498 -5.97634 +3938 4 18.911 24.732 21.3859 -10.0006 10.9377 -12.5795 +3939 6 21.0734 3.08215 14.9508 5.66735 1.93263 4.27485 +3940 4 21.953 3.50152 15.1067 -15.9394 -6.36392 -7.95302 +3941 4 20.9814 2.87634 14.0019 2.73511 2.88399 3.27523 +3942 6 16.4416 12.1461 28.5328 0.855962 3.79198 1.54672 +3943 4 16.9672 12.6551 29.168 -2.37031 -0.949071 -4.41291 +3944 4 15.802 12.7688 28.1665 0.405815 -3.95107 1.98596 +3945 6 29.5641 4.71626 21.7415 17.492 -20.3905 -14.0863 +3946 4 29.717 3.79719 21.4198 0.937107 17.7735 8.56359 +3947 4 28.6765 4.939 21.4721 -9.06619 5.19467 -0.439365 +3948 6 47.4133 12.088 13.4013 -19.6032 -12.6622 16.1152 +3949 4 46.7677 12.2286 12.6843 7.8139 0.82382 7.69043 +3950 4 46.8958 11.6888 14.1608 19.5987 16.3505 -27.3211 +3951 6 26.4348 0.0314913 5.59163 -38.6673 11.9556 1.59378 +3952 4 25.5144 0.513751 5.59151 44.3701 -31.5426 2.21012 +3953 4 26.2832 40.9933 5.84663 -4.6239 23.4679 -5.56234 +3954 6 20.8211 34.8097 41.3598 6.97593 19.5597 16.9804 +3955 4 20.8796 35.753 41.6458 -3.00787 -20.9192 -8.75426 +3956 4 21.5767 34.358 41.784 -4.89338 4.10004 -2.4608 +3957 6 12.6876 17.479 1.38718 -1.79098 16.5747 12.6529 +3958 4 12.721 17.2085 2.3151 1.79447 -6.15344 -4.56661 +3959 4 12.6249 16.7029 0.834077 -0.882684 -12.7315 -6.97767 +3960 6 30.0809 10.1879 8.41184 2.17826 -2.71045 -21.4672 +3961 4 29.3744 10.7602 8.07412 2.70218 -2.7161 1.39802 +3962 4 29.921 10.0821 9.33998 -2.4398 0.0699553 19.6849 +3963 6 36.338 5.45526 23.9203 5.99313 10.0946 16.1749 +3964 4 36.1182 6.35936 23.6236 3.48165 -5.42435 1.21963 +3965 4 37.0503 5.55216 24.5976 -11.7354 -2.45534 -11.6386 +3966 6 34.0137 39.9398 19.5054 17.9066 -9.75089 21.0607 +3967 4 34.5988 39.5452 20.1731 -15.7075 -1.02338 -1.83906 +3968 4 34.6431 40.5289 19.082 -7.6391 9.5881 -14.1485 +3969 6 25.1112 29.0201 17.0007 35.0878 36.529 -22.1514 +3970 4 24.4917 28.3695 17.2244 -30.3786 -36.8419 16.5077 +3971 4 24.8604 29.2867 16.1023 2.15056 -2.21883 6.37313 +3972 6 28.5036 21.3308 6.52422 21.0338 -5.55128 30.7615 +3973 4 28.0688 21.6386 5.71574 5.06238 16.4658 -0.926129 +3974 4 28.989 22.0506 7.05137 -24.5794 -13.751 -30.0602 +3975 6 18.6637 26.1498 0.432001 -8.53447 25.4727 10.2843 +3976 4 18.1393 25.3713 0.533905 -9.92127 -26.6833 -5.54807 +3977 4 18.1707 26.7698 1.00478 10.6071 3.27379 -7.60185 +3978 6 10.9817 29.7047 15.4617 -41.5317 11.7513 13.4553 +3979 4 11.6879 29.3608 14.9846 35.2501 -21.9962 -32.1318 +3980 4 11.3889 29.9926 16.2601 5.02956 8.45945 23.8164 +3981 6 33.4827 3.76017 10.5773 -2.41261 -0.304069 24.838 +3982 4 33.4731 3.39919 11.5182 2.46452 11.5285 -31.0446 +3983 4 33.5847 4.73535 10.6555 -0.240223 -15.9168 2.16837 +3984 6 12.2973 28.805 23.0387 -1.70787 -5.55619 5.61474 +3985 4 12.73 29.6571 22.9381 2.67417 5.94729 -0.690524 +3986 4 11.5024 28.994 23.5653 2.03311 -0.198261 -3.05575 +3987 6 13.0915 10.291 41.0216 -35.9662 5.53295 8.52282 +3988 4 13.8386 10.0408 41.5246 29.6538 -8.48465 17.7322 +3989 4 13.4107 10.5366 40.1733 8.17866 7.18603 -23.992 +3990 6 45.8162 29.981 22.3537 -23.4909 -34.782 -9.94688 +3991 4 46.3605 30.6906 22.6479 19.8522 18.211 11.3118 +3992 4 46.1638 29.1315 22.7274 -3.04842 19.9099 -5.39144 +3993 6 41.5671 12.1372 14.78 12.0724 6.03101 -10.0784 +3994 4 40.8481 12.1001 15.4119 -11.2612 -2.38036 6.73971 +3995 4 41.9114 13.0311 14.8874 5.93112 4.19505 -0.667369 +3996 6 18.1729 7.20363 24.1739 -28.0382 48.7978 3.52623 +3997 4 17.4064 7.85498 24.128 33.406 -18.9268 -1.93395 +3998 4 17.7199 6.38321 24.1568 -14.2968 -40.16 -0.285645 +3999 6 1.47767 28.308 7.57167 -25.5616 27.2209 -25.1393 +4000 4 0.827452 27.622 7.68711 2.49251 -16.9659 6.86802 +4001 4 0.906232 29.0217 7.18328 24.331 -5.18373 6.93061 +4002 6 11.3359 12.3164 24.0718 -23.8013 37.4997 -14.7667 +4003 4 11.6691 13.0224 24.6595 3.51665 -15.1291 3.43827 +4004 4 11.6925 11.4858 24.3227 20.8697 -21.176 20.4973 +4005 6 17.9852 40.4684 24.4198 -2.05389 -13.7174 33.2687 +4006 4 18.291 40.9889 23.6947 8.79563 24.1615 -11.819 +4007 4 17.8495 41.0209 25.2243 7.13458 -7.65509 -20.9696 +4008 6 25.5964 7.43792 34.0141 13.5012 12.0052 -20.5927 +4009 4 25.8913 7.969 33.2287 -3.90825 -14.1502 17.4414 +4010 4 24.6674 7.63663 34.1466 -9.57807 0.741149 3.27376 +4011 6 16.9692 36.3856 7.79034 -41.9934 -28.8773 9.66508 +4012 4 16.1027 35.9203 7.98218 37.4859 8.56847 -14.648 +4013 4 16.8197 37.2026 8.24874 12.7807 20.325 5.07796 +4014 6 12.4125 39.1679 36.8113 4.83627 -30.6012 -9.1357 +4015 4 13.2866 39.4994 36.9682 3.20673 22.8904 8.84646 +4016 4 12.7018 38.3069 36.4569 -23.4958 5.90479 1.90955 +4017 6 23.4443 1.91649 37.7131 1.30421 0.985484 -2.89526 +4018 4 22.7028 1.66545 37.1374 7.60384 11.2995 4.79583 +4019 4 23.7753 2.79308 37.4363 -6.35903 -5.24233 -3.11404 +4020 6 26.6169 34.8556 39.068 -18.8945 24.0174 -16.1573 +4021 4 25.9011 35.0209 39.7003 9.00825 -5.11239 -0.809586 +4022 4 26.448 35.531 38.356 7.64302 -20.2436 14.8851 +4023 6 44.7566 35.572 23.174 8.53117 -4.94531 -21.3447 +4024 4 44.5551 36.3183 23.7275 -7.66893 11.3086 12.1688 +4025 4 44.9082 35.9286 22.2729 -0.906387 -11.1819 10.3159 +4026 6 34.6091 35.4265 26.6991 -7.96701 8.74937 -1.29134 +4027 4 33.7558 35.2865 27.1578 16.0802 3.93421 -4.37465 +4028 4 35.2785 35.5457 27.4013 -9.86041 -2.80018 -4.60569 +4029 6 12.4308 29.8402 9.37325 4.00701 15.5633 13.1387 +4030 4 12.6298 30.2095 10.2592 0.427445 -8.8693 -11.9579 +4031 4 11.9163 30.5385 8.94302 -0.259504 -4.09781 -0.505047 +4032 6 46.4536 41.3715 16.9585 -0.509472 -10.7221 -3.48983 +4033 4 46.3968 0.20327 17.5639 0.209317 7.43894 6.10767 +4034 4 46.3711 41.769 16.0793 0.075994 -2.20044 0.741492 +4035 6 39.1811 31.047 24.0166 -28.3946 14.7902 -31.7872 +4036 4 39.0009 31.2944 23.0615 15.0891 -8.50563 28.3067 +4037 4 38.282 31.1199 24.3765 13.6746 -2.33731 7.34059 +4038 6 40.5375 9.75603 28.9763 9.47615 -22.8392 -16.3574 +4039 4 40.717 8.78834 28.9749 -4.02124 18.0325 0.597023 +4040 4 40.0442 9.94417 29.7674 -4.45736 4.50836 13.2228 +4041 6 33.5752 11.9033 22.735 -22.7947 23.9621 15.9921 +4042 4 33.2963 12.1808 21.8555 7.18969 -8.33444 -8.87292 +4043 4 33.0376 12.5465 23.2695 22.9257 -24.0379 -3.52442 +4044 6 29.0301 38.739 2.44557 13.7604 -11.9544 -20.6568 +4045 4 29.2066 39.6607 2.23242 1.09325 2.62923 1.14408 +4046 4 28.4566 38.7797 3.20164 -8.68487 1.4276 10.4377 +4047 6 51.2789 6.14828 28.303 0.614736 -0.570337 1.8431 +4048 4 51.6973 5.27456 28.1665 -1.53436 11.093 -0.261734 +4049 4 51.6265 6.73477 27.6091 2.17001 -12.1019 4.10374 +4050 6 34.1129 16.6124 14.0322 -32.0491 -20.8609 -4.49638 +4051 4 33.8537 17.5241 13.9801 -4.99199 17.3104 -1.82528 +4052 4 35.0495 16.5739 14.0336 36.3732 5.94549 -0.19423 +4053 6 34.4398 40.0505 7.51971 -1.5967 1.86622 -34.5907 +4054 4 34.4907 40.736 6.82898 6.47702 11.7366 29.0204 +4055 4 34.1466 39.3906 6.89306 -3.09667 -23.6565 15.965 +4056 6 42.5416 22.9885 4.36731 16.709 1.02816 -9.65968 +4057 4 42.6773 23.0677 3.40021 -12.3994 2.37358 9.8727 +4058 4 41.6332 23.2481 4.59133 5.34809 1.54884 -5.45539 +4059 6 1.43335 11.7249 10.5915 17.9648 34.7983 -1.93775 +4060 4 2.18855 11.6351 9.93392 -25.2532 9.63542 18.7746 +4061 4 1.3761 12.7012 10.8984 13.7257 -41.7135 -20.7702 +4062 6 10.0197 17.1509 40.4023 -3.34945 -21.541 12.0793 +4063 4 9.07741 16.8499 40.449 26.596 5.40866 2.75879 +4064 4 10.6028 16.482 40.874 -24.6204 18.7768 -14.392 +4065 6 26.3793 1.16939 23.7984 9.5834 26.112 -20.0106 +4066 4 26.3482 1.63114 22.915 -1.08564 -15.7005 23.7132 +4067 4 26.8817 1.81632 24.3342 -3.35925 -10.5223 -0.68284 +4068 6 4.47487 16.2271 39.0058 33.4959 -10.553 -10.6989 +4069 4 4.63618 15.8937 38.0801 -2.33968 7.70086 24.4633 +4070 4 5.35244 16.1813 39.5129 -32.5033 1.65679 -19.7071 +4071 6 24.3835 39.8482 14.0852 2.84697 7.18038 -0.286146 +4072 4 24.1877 40.6985 13.6429 5.77715 -11.144 2.19115 +4073 4 25.1234 39.4426 13.6288 0.754333 1.29636 -3.16103 +4074 6 19.9701 19.0136 10.1131 -5.22385 -12.8057 23.8822 +4075 4 19.1001 19.3633 10.3498 -0.643873 5.13605 -7.14836 +4076 4 20.1315 18.3631 10.8504 3.64009 16.176 -24.2707 +4077 6 45.2329 15.0638 25.3099 -19.5547 20.2245 12.2671 +4078 4 44.4482 15.622 25.4263 4.62838 7.04728 2.57625 +4079 4 44.8851 14.3824 24.752 0.155489 -22.5403 -14.0061 +4080 6 47.6439 32.9533 29.9771 4.38746 -1.69347 6.40492 +4081 4 47.8622 32.5347 30.8309 -5.05982 6.77924 -7.14273 +4082 4 46.6855 33.0215 29.8843 -3.06966 -4.44082 4.14054 +4083 6 9.30872 14.1631 35.6268 19.7088 14.7601 29.7215 +4084 4 10.221 13.8687 35.4779 -5.99131 -8.3331 -9.89462 +4085 4 9.36538 14.5282 36.5395 -10.4264 -5.45721 -18.9107 +4086 6 0.534978 28.7509 32.1461 -15.0727 14.1973 -4.1115 +4087 4 0.468283 29.1163 31.2513 -2.72678 6.96628 5.64212 +4088 4 0.834469 27.866 31.9601 7.81775 -11.1437 7.49829 +4089 6 26.1375 14.1816 40.8286 20.1166 -40.7048 30.4826 +4090 4 26.3241 13.5573 41.5993 3.0023 20.8863 -27.3959 +4091 4 25.2151 14.3343 40.9319 -22.5068 13.4131 -3.44564 +4092 6 38.0468 1.72227 37.358 -19.6589 11.4537 -4.22791 +4093 4 38.2764 1.77906 36.4154 -1.14244 -2.14966 7.97792 +4094 4 37.182 2.20858 37.4052 20.9639 -13.8426 2.93072 +4095 6 43.3928 21.0193 0.385094 -33.4221 -4.11839 13.5226 +4096 4 43.2305 21.8771 0.864972 20.5484 -13.2955 -16.2126 +4097 4 44.243 20.9573 41.8451 7.78799 18.4844 3.58779 +4098 6 29.7343 12.3918 17.0888 -10.4088 14.6249 -44.7733 +4099 4 30.3573 13.1084 17.3121 -1.69191 -12.5137 15.8564 +4100 4 29.5365 11.7717 17.7855 9.28071 1.18848 24.195 +4101 6 21.0845 11.002 35.643 19.2467 11.9534 29.728 +4102 4 20.8387 11.9292 35.5336 -5.23529 -0.657509 -1.91086 +4103 4 20.6782 10.509 34.9529 -15.7216 -13.7754 -25.5995 +4104 6 24.3584 22.1274 17.054 -19.116 4.6391 -13.6617 +4105 4 24.8062 22.8618 16.6504 0.246813 15.5697 -7.02352 +4106 4 25.0581 21.6899 17.4914 19.3443 -19.237 19.9016 +4107 6 44.2632 9.62803 6.15095 12.4515 -7.11379 4.41615 +4108 4 44.6939 9.46248 5.31272 4.1824 -3.3463 -6.13814 +4109 4 43.3875 9.94101 5.94426 -13.441 6.05535 2.74078 +4110 6 40.7983 2.89203 6.29118 6.30341 -5.06299 2.94692 +4111 4 40.283 3.08384 7.0886 -2.93464 8.08246 -11.2803 +4112 4 40.6425 3.53992 5.58152 -5.48248 3.30556 7.46891 +4113 6 23.4927 29.787 25.2074 -17.9847 -14.6764 23.1638 +4114 4 22.9663 29.9524 24.4255 0.505661 2.84572 -7.25135 +4115 4 24.3189 30.243 25.1366 19.4862 15.0746 -12.06 +4116 6 45.2253 20.6067 7.48804 -4.5495 -5.9569 -0.737791 +4117 4 44.4771 20.6075 6.85512 7.98227 -4.73543 5.3389 +4118 4 45.4897 19.6858 7.65762 -3.7219 7.49041 -4.48952 +4119 6 44.1869 26.5802 16.6604 -2.53584 -23.4697 22.3036 +4120 4 44.4278 26.4187 15.7655 11.491 9.41288 -34.0672 +4121 4 43.9629 25.6676 16.9 -3.51956 3.82806 13.7521 +4122 6 23.5847 27.0608 18.0875 4.92857 -1.63386 -8.1099 +4123 4 23.1417 26.2886 17.6568 -1.85204 16.5134 12.3838 +4124 4 22.9956 27.5067 18.7318 1.2523 -15.787 -12.8337 +4125 6 45.1423 16.1006 8.91925 -12.5826 4.07054 -12.5551 +4126 4 44.1756 16.0018 8.7625 13.8686 2.25455 7.61002 +4127 4 45.2849 15.9649 9.86163 -1.87368 -3.25302 7.37304 +4128 6 39.0195 15.168 5.20911 22.9796 -5.95468 -13.3261 +4129 4 39.8169 15.5451 4.76197 -16.8333 -0.501818 4.44847 +4130 4 38.2997 15.7872 5.12886 -6.79784 14.0419 -3.1922 +4131 6 40.4728 4.77172 20.098 -25.5728 -7.96759 5.38455 +4132 4 41.2852 4.73631 19.62 25.1414 0.345713 -9.53623 +4133 4 40.6586 5.20983 20.9254 2.90807 4.2574 9.49937 +4134 6 35.8334 28.4358 39.8978 -29.6544 -30.7382 0.627816 +4135 4 35.064 27.7738 39.8775 30.8234 30.4338 1.60118 +4136 4 36.4992 28.0138 39.3349 2.0747 -0.608826 -0.916217 +4137 6 26.5626 3.56604 2.67563 -12.8067 -1.70274 -2.52813 +4138 4 26.0244 3.493 1.8476 6.72613 8.7381 24.6483 +4139 4 26.0719 4.09981 3.36162 5.66066 -13.1585 -23.5937 +4140 6 2.95645 21.6514 17.6824 -3.82104 6.40043 0.291571 +4141 4 2.91294 22.1823 18.4797 -6.37673 0.600795 10.7096 +4142 4 3.68258 22.033 17.1814 1.62588 2.51689 -6.09233 +4143 6 12.886 25.0591 25.9256 19.9254 19.7817 -8.37483 +4144 4 13.3104 25.904 25.618 -13.2675 -16.998 3.60223 +4145 4 12.0452 24.9678 25.4656 -4.65807 1.85418 -5.64346 +4146 6 41.5793 20.6554 14.1751 9.92193 3.46069 0.25892 +4147 4 42.3122 20.2044 13.7523 0.767115 -12.7084 -7.64783 +4148 4 41.9959 21.4893 14.4245 -8.84771 2.34114 1.73285 +4149 6 1.24495 39.6039 11.5378 16.0363 -42.6363 3.17437 +4150 4 1.64626 38.7705 11.134 -18.3255 36.4754 4.46196 +4151 4 1.41802 39.4632 12.4909 -5.9615 12.3362 -8.98123 +4152 6 16.0218 39.0109 34.0619 -0.331369 12.6721 -5.4452 +4153 4 15.5475 38.1996 33.7806 5.75571 19.7523 -4.5346 +4154 4 15.9899 39.7855 33.4251 -7.29137 -28.599 9.21448 +4155 6 20.567 7.02475 25.5588 2.3848 7.82756 -0.6535 +4156 4 20.909 7.86076 25.1782 -7.45606 -9.2474 3.61042 +4157 4 19.6275 6.99553 25.3185 5.42042 5.25175 -3.5088 +4158 6 45.1928 25.5902 39.1787 -21.925 2.17874 18.9559 +4159 4 45.8631 26.0435 38.6892 20.8233 13.1115 -15.3132 +4160 4 45.3324 24.6675 39.0115 4.42968 -17.7425 -2.36405 +4161 6 19.9342 40.1138 28.2835 12.5964 -14.0671 -7.25792 +4162 4 19.0067 40.1593 28.0096 1.46425 5.68018 7.52545 +4163 4 20.128 40.8224 28.917 -7.48392 0.334406 -3.99949 +4164 6 26.4878 14.2069 27.3684 6.98603 -7.23951 -28.1548 +4165 4 25.5412 14.1932 27.2537 -20.7302 0.754551 -2.34698 +4166 4 26.606 14.4537 28.2745 0.836708 4.29804 26.5652 +4167 6 51.3489 25.9487 3.45136 10.7849 20.7191 -13.686 +4168 4 51.0453 25.2386 4.01334 -1.8549 -15.8565 1.21982 +4169 4 51.853 25.5737 2.69356 -6.32678 0.0553236 13.0587 +4170 6 20.1633 26.1247 2.67289 8.83438 -16.1267 5.68002 +4171 4 20.5345 25.2411 2.88723 -1.43181 13.9101 -1.64203 +4172 4 19.9438 26.1088 1.72974 -0.778515 0.427063 3.21599 +4173 6 3.13549 11.9681 27.2232 16.3616 22.3682 9.86323 +4174 4 2.68005 12.663 26.7181 4.92926 -3.58697 -0.471129 +4175 4 3.70389 12.4466 27.8862 -15.0224 -10.9098 -14.9284 +4176 6 30.1793 26.3687 4.00051 28.7119 -30.2966 58.1206 +4177 4 30.7801 25.8341 3.46925 -1.584 2.83444 -17.1702 +4178 4 29.6371 26.9341 3.51662 -25.563 30.6813 -37.7958 +4179 6 19.3205 20.6733 30.5441 -31.721 -6.25106 8.6959 +4180 4 19.1895 21.5008 31.0287 11.509 1.10551 -1.6952 +4181 4 20.2026 20.5869 30.2 22.6938 9.52703 -0.947482 +4182 6 13.5381 36.2475 0.344803 0.685356 24.2985 -17.2657 +4183 4 13.9232 37.1122 0.0997808 14.0363 -10.2996 17.9143 +4184 4 12.867 36.2368 41.5779 -17.3214 -19.7281 -1.62589 +4185 6 13.6931 21.7661 35.9637 -11.3229 -11.9655 -19.5688 +4186 4 13.4645 21.416 35.0694 1.68887 6.71419 14.5774 +4187 4 14.5559 22.1488 35.8465 12.3178 6.48213 0.887249 +4188 6 39.4176 1.76287 25.342 34.0854 -16.9064 9.57103 +4189 4 40.0026 2.33061 25.8435 -14.6367 28.4588 7.32056 +4190 4 40.0689 1.04185 25.2643 -19.5027 -7.65211 -10.5764 +4191 6 18.2964 6.13492 35.8264 -1.82227 -5.92686 -23.3299 +4192 4 18.1639 5.26767 36.254 2.04199 12.8657 6.45456 +4193 4 18.4232 6.85005 36.4651 0.375802 -9.94466 7.47089 +4194 6 2.53148 24.639 10.0969 -49.4669 34.6161 -0.50772 +4195 4 3.3243 24.1433 10.0889 43.7683 -7.59463 9.24933 +4196 4 2.65209 25.5465 10.4987 14.0059 -27.2835 -7.72375 +4197 6 35.8204 9.94567 1.34298 17.6587 14.9905 11.506 +4198 4 36.311 10.4135 0.64327 -4.10869 -3.12473 7.53129 +4199 4 36.1923 10.315 2.19711 -13.0886 -16.0695 -26.9686 +4200 6 29.0171 17.933 41.5847 -7.4648 10.4738 41.1296 +4201 4 28.4325 17.2741 41.1888 4.90819 -0.226834 -17.309 +4202 4 29.634 18.3354 40.9804 6.59061 1.40283 -25.0927 +4203 6 46.0097 27.0807 25.8707 -17.7195 2.90801 -6.40423 +4204 4 46.7639 26.9189 26.4445 5.86789 -6.79057 7.62258 +4205 4 45.3727 26.3443 25.9794 8.73043 2.74283 1.98831 +4206 6 28.1087 10.6569 35.9055 -15.3417 -26.5964 -30.9314 +4207 4 27.3182 11.0018 35.4375 11.5227 2.30745 10.116 +4208 4 28.4572 11.2922 36.5111 4.26863 23.9808 15.1461 +4209 6 25.95 20.1976 24.7821 3.31321 9.63686 -4.79579 +4210 4 26.7637 20.7132 24.6155 -9.40037 -7.04512 10.7501 +4211 4 25.7749 20.1865 25.7378 6.19451 4.49283 1.81458 +4212 6 32.2481 30.2487 10.2005 -0.567171 -33.888 25.4585 +4213 4 32.5217 30.8918 9.54162 14.407 -2.03846 -6.18424 +4214 4 32.9483 29.5597 10.4163 -8.30199 27.6945 -16.8968 +4215 6 5.04696 34.3919 23.8165 18.9071 9.10073 -2.65681 +4216 4 5.8517 34.9395 23.7378 -5.43375 -12.4066 7.00495 +4217 4 4.47737 34.8578 23.2154 -15.6684 -1.23826 -5.97721 +4218 6 29.6446 34.9396 23.1073 8.37026 13.2143 1.46186 +4219 4 30.146 35.227 23.8877 -4.79805 -2.96005 -2.8646 +4220 4 29.6355 33.9874 23.1398 -0.169507 -13.2925 4.62646 +4221 6 52.2021 25.2197 36.2484 0.203165 -13.9358 18.8619 +4222 4 51.9199 25.3821 37.1814 5.20177 -0.668093 -22.6011 +4223 4 52.2823 24.2449 36.2046 0.468647 8.20491 -0.432122 +4224 6 6.9564 41.2598 14.9786 17.963 -12.3423 -19.5336 +4225 4 7.05881 41.0384 15.8913 -5.14113 -1.34859 16.0369 +4226 4 7.66895 40.7276 14.5577 -14.5347 12.9973 2.09466 +4227 6 27.6566 39.1405 4.67566 -15.1179 -12.1251 22.0677 +4228 4 26.8424 38.6352 4.89635 10.0979 9.09612 -9.05456 +4229 4 28.2356 39.0161 5.44259 -0.0995191 -2.46215 -4.35417 +4230 6 44.4488 15.8848 30.3925 -17.4686 4.63448 -32.2897 +4231 4 43.6243 16.41 30.3099 13.0937 -10.0294 9.08699 +4232 4 44.649 15.6212 29.457 1.77951 4.94888 23.2191 +4233 6 27.3024 38.1054 13.0907 0.224949 -17.5042 -4.12929 +4234 4 27.6483 37.328 12.5833 -5.61487 10.2238 13.6353 +4235 4 27.1416 37.8221 14.0243 3.20236 0.189733 -16.1751 +4236 6 26.6663 32.9851 36.8362 -23.8807 -10.2072 10.655 +4237 4 27.4028 33.4987 36.5569 24.2269 11.6336 -10.1628 +4238 4 26.2735 33.5165 37.5295 -1.35435 2.25064 8.62378 +4239 6 26.3226 28.1988 31.7158 32.4613 11.5871 5.04411 +4240 4 26.7492 28.3346 30.8217 -6.54697 -0.873531 32.5908 +4241 4 26.9302 28.5068 32.4691 -17.7353 -8.90623 -33.5497 +4242 6 49.2114 35.7792 23.3295 1.46842 19.8344 9.76806 +4243 4 49.8184 36.2235 23.9243 -3.28067 3.63886 4.6357 +4244 4 49.746 35.0988 22.9506 10.5329 -22.9043 -16.5919 +4245 6 44.2369 15.3613 33.5367 -0.695853 -9.37614 14.4104 +4246 4 44.9539 15.1613 32.9326 3.59625 1.2978 -8.28609 +4247 4 43.6189 15.9562 33.0977 0.720121 5.36694 -8.04858 +4248 6 16.6517 35.2697 14.032 -14.9609 -5.91625 -15.8105 +4249 4 16.8478 36.086 14.4923 5.97715 10.4369 8.21626 +4250 4 15.7311 35.3947 13.7134 15.021 -1.16653 5.16189 +4251 6 45.2991 21.4701 12.0564 -47.5016 11.1637 19.3857 +4252 4 45.9844 21.105 11.5386 20.9258 -26.0087 -22.2564 +4253 4 44.5936 20.7913 12.2178 25.8967 12.3347 -6.55717 +4254 6 51.6438 5.33792 20.1099 7.42219 12.4384 36.9688 +4255 4 51.7517 5.79258 20.9932 -2.42789 -17.2577 -23.3969 +4256 4 50.9203 5.81642 19.7 -6.55397 4.36408 -6.3714 +4257 6 22.6153 27.305 0.955308 -12.5158 1.22245 6.52354 +4258 4 21.8819 27.8542 1.31405 9.62632 -7.19502 -8.89748 +4259 4 23.0385 27.8458 0.276527 0.370713 4.24399 -0.0338259 +4260 6 46.8868 12.1467 22.3289 10.3551 9.03073 -1.70047 +4261 4 46.473 12.5446 21.5671 -2.12653 7.07083 -14.4911 +4262 4 46.1639 11.6922 22.7348 -15.0603 -15.1984 17.3736 +4263 6 33.7555 5.60359 25.2366 8.41588 -11.9289 0.48427 +4264 4 34.4013 5.10188 24.7086 -2.4022 4.68399 3.96997 +4265 4 33.0757 5.86414 24.6127 -5.93503 4.46215 -0.558809 +4266 6 44.2476 18.1243 27.2334 30.0322 17.9475 -5.65933 +4267 4 44.0927 18.7931 26.5253 0.465456 -9.97561 17.2792 +4268 4 45.207 18.2464 27.4768 -29.0014 -6.50023 -5.41996 +4269 6 5.27814 37.006 29.0846 -42.995 37.8911 -11.235 +4270 4 4.83357 37.8684 28.7516 22.264 -36.721 16.075 +4271 4 6.19253 37.2033 29.2507 20.6764 5.54169 3.86921 +4272 6 20.033 5.01392 38.9409 6.34377 -32.2179 -4.45843 +4273 4 19.8009 5.56625 39.6765 -4.47316 13.7366 14.9565 +4274 4 20.2948 4.14306 39.3359 -6.8578 18.535 -7.22498 +4275 6 17.9112 2.77214 33.8677 -16.6976 6.01838 23.4157 +4276 4 18.6113 3.34266 33.5322 6.18073 5.31505 -2.96417 +4277 4 17.3526 3.28629 34.5246 17.6921 -17.568 -20.3177 +4278 6 5.56788 23.3774 22.3326 -7.55986 13.5725 18.1102 +4279 4 6.25354 23.3408 21.6412 1.32241 8.57002 8.68476 +4280 4 5.72116 24.1623 22.9232 3.31135 -14.4794 -19.5174 +4281 6 12.7438 28.0244 40.0809 14.6998 26.4392 -25.8726 +4282 4 12.8099 29.0023 40.1455 -0.120572 -14.3051 2.54846 +4283 4 13.1526 27.8611 39.1965 -9.74214 -4.86635 20.6942 +4284 6 50.5283 38.8014 28.4207 -10.7676 14.1923 -1.71082 +4285 4 51.0354 39.5212 28.0559 20.7423 0.788408 -10.014 +4286 4 49.7626 39.3052 28.7255 -7.2831 -13.6434 5.52883 +4287 6 33.5501 8.21498 17.8605 -32.9279 -35.4008 39.405 +4288 4 33.9027 8.87262 17.3189 24.9798 40.0041 -36.6225 +4289 4 33.9074 7.37462 17.5752 8.43731 -7.27798 -4.46199 +4290 6 34.6457 34.7004 17.7764 -12.4293 -15.9601 -10.9704 +4291 4 35.1223 35.3606 18.2944 6.48769 -0.751965 0.253856 +4292 4 35.2388 33.9528 17.5616 -1.14344 9.31979 5.2604 +4293 6 40.7233 5.29016 23.4005 8.26322 -6.33781 10.3585 +4294 4 41.4774 4.87923 23.8731 -9.49225 7.91527 -13.3731 +4295 4 40.0307 4.6112 23.3711 2.34129 5.18948 -0.0201455 +4296 6 16.9127 27.7621 14.4682 52.6044 -4.68653 -2.89351 +4297 4 16.0711 28.1345 14.4444 -59.8378 16.6137 -1.60006 +4298 4 17.4608 28.5627 14.561 1.7801 -9.46587 0.070581 +4299 6 29.0363 14.6633 5.00698 9.76413 -9.29226 13.7719 +4300 4 29.5096 13.8001 4.93115 -9.10936 16.1071 1.03458 +4301 4 28.802 14.7746 5.95339 2.50956 -1.40994 -14.9204 +4302 6 36.8445 17.7203 5.07362 13.6951 -24.032 -28.6565 +4303 4 36.3003 18.4061 5.45056 -9.17068 14.5835 0.43155 +4304 4 36.9783 17.8862 4.10178 -4.81067 2.65881 25.6667 +4305 6 27.7152 25.5071 34.8558 20.6182 -10.3116 10.9196 +4306 4 28.4128 25.1948 35.4689 -8.51497 -1.72528 -14.7569 +4307 4 27.3626 26.2325 35.3632 -10.8781 12.0961 2.58089 +4308 6 24.7577 17.2803 18.064 -3.70908 -2.75228 5.17573 +4309 4 25.2464 17.9619 18.5343 4.21458 5.85634 1.04617 +4310 4 24.0216 17.073 18.6635 3.98676 -0.349172 -5.54229 +4311 6 30.1887 1.57939 5.82314 -15.3902 21.7461 -57.8894 +4312 4 29.5204 1.81013 6.46928 0.301846 -2.58557 7.21893 +4313 4 29.8355 2.03332 4.95505 20.4457 -28.7719 49.9963 +4314 6 37.4518 25.9014 8.44867 -40.4019 -33.5071 29.4213 +4315 4 38.3881 25.8301 8.67833 5.27698 -2.9507 2.74989 +4316 4 36.9261 25.2192 9.0364 31.48 35.4073 -33.2345 +4317 6 24.7717 7.01585 2.25321 22.1725 6.13312 -2.42992 +4318 4 25.3573 6.36243 2.67285 -8.4103 6.94319 2.38151 +4319 4 23.8861 6.6751 2.35128 -10.8992 -4.25211 1.65182 +4320 6 25.7992 38.8457 10.7505 7.22571 37.8744 -16.0906 +4321 4 26.2906 38.615 11.5103 14.31 -23.6918 34.358 +4322 4 26.1189 39.766 10.6411 -14.7913 -5.88601 -10.6141 +4323 6 0.557249 13.5851 28.1314 4.10373 25.7622 10.4527 +4324 4 0.335523 12.7734 27.7191 -4.86664 -22.4284 -15.6315 +4325 4 0.332586 13.4422 29.0593 -0.0574933 0.663208 0.855409 +4326 6 20.4027 17.1068 12.0342 -11.148 -26.8285 -23.5414 +4327 4 20.2541 17.2545 12.9674 -4.18463 -1.09026 14.619 +4328 4 19.9228 16.2663 11.7843 12.058 20.2306 8.20324 +4329 6 30.9875 7.38585 16.6706 43.1327 18.1844 -1.13431 +4330 4 31.2844 7.10043 15.7746 -9.95685 2.73348 15.1831 +4331 4 31.8198 7.8213 17.056 -34.7561 -19.1709 -8.28734 +4332 6 10.1956 5.78615 12.1691 19.1166 9.414 40.461 +4333 4 10.1305 6.30649 11.4071 -1.6074 30.0602 -42.5686 +4334 4 9.61456 5.08708 11.9844 -30.6818 -38.1141 -6.43609 +4335 6 18.4382 31.3444 24.1606 1.21336 -6.12525 2.83497 +4336 4 18.3965 30.3858 24.3134 -0.788465 1.61506 0.642095 +4337 4 18.2608 31.7571 25.0112 -0.825834 1.26386 0.0223154 +4338 6 27.8905 29.2615 29.2809 39.8074 15.5588 -29.008 +4339 4 28.4007 29.5348 28.4528 -32.3375 -5.53357 22.8869 +4340 4 28.6323 28.9656 29.8273 -8.8667 -4.73078 13.1255 +4341 6 38.3648 15.4483 29.7818 29.0993 -31.9427 29.9284 +4342 4 38.2401 14.49 30.0972 1.05022 38.774 -16.5136 +4343 4 39.2299 15.7257 30.2111 -34.0699 1.82394 -15.2271 +4344 6 21.7074 34.7851 5.58078 8.19375 -39.9271 5.99876 +4345 4 21.4944 33.8203 5.80476 0.548141 38.153 -5.97617 +4346 4 20.9458 35.3238 5.82701 -5.25279 -7.50871 2.73382 +4347 6 18.2117 16.8293 1.01571 -12.7233 9.06437 9.63769 +4348 4 17.5846 17.1799 0.363518 5.67247 -6.87112 -0.25098 +4349 4 17.8106 17.1001 1.86952 7.78128 -5.5379 -6.7416 +4350 6 43.5131 18.5098 39.3469 22.8992 -24.809 -24.744 +4351 4 42.9473 19.1501 39.756 -14.025 22.4758 -1.21679 +4352 4 43.733 18.7829 38.41 -14.2449 3.90475 27.8798 +4353 6 17.7973 10.0724 35.5497 11.3899 1.25644 -17.5776 +4354 4 17.9076 9.35875 36.1674 -1.9111 -9.85084 12.7139 +4355 4 18.4727 9.8826 34.8661 -11.1758 5.45367 7.50841 +4356 6 36.5836 30.5676 29.0795 -26.735 36.4018 -15.4516 +4357 4 36.5101 31.4618 28.6208 1.83791 -30.0083 14.6126 +4358 4 37.4767 30.2665 28.9506 20.8385 -5.81304 -4.31186 +4359 6 38.5024 35.9654 10.4302 15.5283 7.61871 55.4477 +4360 4 38.713 36.6589 11.1463 -7.3207 -22.805 -33.4203 +4361 4 38.3781 35.1576 10.9824 1.19538 10.4075 -12.7486 +4362 6 43.3976 18.7941 34.3717 -4.38817 -12.2014 30.3889 +4363 4 43.0627 18.1963 33.6763 0.988603 1.53223 14.3474 +4364 4 43.2603 18.4022 35.293 0.0857578 9.32555 -37.8245 +4365 6 11.0576 40.22 6.11206 -6.0837 -9.04747 -4.15047 +4366 4 11.6426 40.8981 6.46389 1.08734 7.77423 2.35531 +4367 4 10.1474 40.5638 6.06331 9.30243 4.06404 0.87098 +4368 6 48.3282 13.7431 24.4718 -8.87905 25.3224 16.0087 +4369 4 47.8536 13.4091 23.7195 -8.5266 -8.47545 -16.9724 +4370 4 47.8942 14.6072 24.6749 14.3726 -19.4181 -2.72093 +4371 6 1.47819 25.7805 23.7819 -0.0731812 -13.4431 -3.72387 +4372 4 0.822875 26.4404 23.4927 11.4147 5.84295 7.97453 +4373 4 2.19403 26.202 24.2849 -5.19934 9.21725 -1.17005 +4374 6 20.5754 0.0393205 21.1081 25.6075 5.05031 -17.3956 +4375 4 19.8484 0.361847 21.622 -17.4675 -5.38456 12.9096 +4376 4 20.5586 40.9849 21.0455 -11.1839 1.66381 7.6849 +4377 6 37.6642 12.8991 30.7037 -9.9457 -20.8438 -29.8221 +4378 4 37.1371 12.462 29.9889 18.2914 6.1257 8.16018 +4379 4 36.9745 13.1334 31.2979 -14.5618 11.4049 21.409 +4380 6 49.47 17.3794 9.25364 5.30826 8.19981 -9.14457 +4381 4 48.5231 17.6061 9.31556 15.6584 -1.48937 -5.70503 +4382 4 49.8852 17.9254 8.53549 -14.9109 -12.0851 17.4703 +4383 6 34.3662 5.35535 17.144 13.1974 2.57034 -29.0571 +4384 4 34.5198 5.2998 16.166 0.54303 4.43319 20.4174 +4385 4 33.4623 5.07036 17.243 -16.3394 -6.24992 8.38082 +4386 6 14.7833 27.6665 0.0728061 -6.74966 -7.64198 -7.69033 +4387 4 13.9925 27.8402 41.4242 12.1928 3.48747 9.75107 +4388 4 15.1668 28.5017 0.401621 -7.96817 -0.0208253 -5.02821 +4389 6 48.8656 15.5206 20.7458 -9.86138 0.136748 20.6241 +4390 4 49.0651 16.3952 20.4263 0.209458 6.72405 -7.85333 +4391 4 49.1204 14.8922 20.0789 6.79298 -9.16117 -16.8166 +4392 6 23.807 40.3882 20.3905 -3.398 23.5063 24.1729 +4393 4 23.5208 41.0259 21.1064 9.42377 -19.8715 -22.5683 +4394 4 24.7282 40.1652 20.6096 -6.91059 4.34471 -3.10789 +4395 6 35.1847 31.5046 13.7021 -31.0181 23.9456 -35.1619 +4396 4 34.2309 31.3725 13.4471 24.927 2.88592 7.27171 +4397 4 35.3946 30.8036 14.2945 4.95161 -20.634 19.3451 +4398 6 10.9658 9.01332 39.5058 -15.2714 21.9147 -18.395 +4399 4 10.5965 9.92979 39.4 9.97221 -25.6919 2.69722 +4400 4 11.1763 8.90125 40.4322 -2.36933 4.41176 3.08643 +4401 6 53.2091 4.88966 16.6226 -14.1926 -12.3632 -40.3028 +4402 4 53.7513 5.3458 17.242 7.58091 5.46958 35.753 +4403 4 52.4727 4.38631 17.0042 6.19997 4.37068 9.30068 +4404 6 7.84194 33.803 26.1542 28.433 15.6582 -32.2535 +4405 4 7.6241 34.0763 27.0539 6.31302 8.01731 -0.629847 +4406 4 8.43319 34.4994 25.6777 -29.4311 -29.3345 32.8186 +4407 6 31.3263 27.9445 6.27534 4.23256 -31.0286 -11.1959 +4408 4 31.9071 27.4889 6.92578 -8.71467 11.4818 -6.48617 +4409 4 31.157 27.2952 5.54778 3.06851 13.2477 11.4148 +4410 6 31.3665 2.16522 41.0549 8.67281 8.84877 18.675 +4411 4 31.764 2.22522 0.0553479 -13.0589 -8.62932 -24.7178 +4412 4 31.1679 1.24258 40.8683 -0.324156 -6.15668 4.61941 +4413 6 33.7659 4.25511 35.8987 -17.0312 -3.82062 1.06926 +4414 4 34.343 3.86214 36.5812 -9.75418 2.24627 -3.55813 +4415 4 32.8029 4.08293 36.1352 33.1171 1.27305 -1.46623 +4416 6 47.9658 16.0637 29.8469 2.67107 -7.93457 21.4822 +4417 4 48.7643 16.2814 30.3583 0.589987 0.219824 -12.8585 +4418 4 47.4335 15.6159 30.5321 -1.60863 4.8928 -15.0046 +4419 6 49.3312 10.0914 28.5924 -0.28152 -2.80953 -5.35856 +4420 4 48.5695 10.6519 28.8218 4.15282 -2.34898 -5.74021 +4421 4 49.4995 10.1231 27.6243 -2.44246 2.9592 14.5426 +4422 6 21.4058 27.7857 29.7524 8.26148 -8.5709 13.934 +4423 4 21.8935 27.2574 30.4222 -7.07544 0.199766 -18.4014 +4424 4 21.2999 28.6278 30.1835 -3.48366 18.9655 1.67033 +4425 6 11.6744 39.4982 25.8468 7.90293 7.18169 -2.58674 +4426 4 12.2285 38.7361 26.0681 1.40058 3.92388 1.36909 +4427 4 10.8023 39.1241 25.7384 -12.6269 0.672841 -0.990747 +4428 6 22.9696 39.3076 7.85132 -6.07512 -3.4122 -1.68244 +4429 4 22.2682 38.6524 7.98148 0.173976 5.86283 1.52023 +4430 4 22.7132 40.0561 8.41581 1.67877 -3.24138 -2.90234 +4431 6 42.551 35.9177 31.3369 11.821 -63.1978 11.5341 +4432 4 42.5803 35.466 30.4647 -4.4966 22.226 11.3725 +4433 4 42.4036 36.8376 31.2573 -6.84366 36.9754 -14.9488 +4434 6 33.6582 14.7374 3.97797 20.0935 -7.17859 -40.4554 +4435 4 32.8645 15.2412 4.10613 -20.5582 11.3796 6.05129 +4436 4 33.8494 14.8388 2.99484 -4.26498 -3.76663 30.6135 +4437 6 36.6985 8.59579 17.521 17.5186 -20.4505 -17.8166 +4438 4 37.2174 8.05238 16.87 -10.1577 15.2162 18.3492 +4439 4 36.2061 9.2161 16.9727 -6.85471 3.87096 1.58869 +4440 6 20.8134 32.4132 17.3224 -0.15138 -19.2041 8.32641 +4441 4 20.2101 33.0681 16.9297 -8.31182 -6.81981 10.9196 +4442 4 20.3788 31.7527 17.9441 5.10322 26.2393 -19.6477 +4443 6 20.7088 35.3183 14.0957 -11.7768 -25.3725 -13.8548 +4444 4 21.261 35.5893 13.3574 6.77827 9.37653 -4.07387 +4445 4 20.8679 35.9028 14.8214 6.04206 13.2639 9.85712 +4446 6 20.2377 2.51389 40.1721 -7.12285 -8.41588 24.6249 +4447 4 19.7963 2.31331 41.0421 14.3479 1.04867 -24.2175 +4448 4 20.7189 1.71371 39.9103 -4.456 1.41042 1.49289 +4449 6 15.0332 14.4679 0.20602 13.2809 -6.14192 -34.7112 +4450 4 15.5535 13.6508 41.8516 -13.9549 30.8146 5.37449 +4451 4 15.3124 15.2392 41.5458 -1.11857 -25.4589 11.3055 +4452 6 24.8198 37.3334 18.5262 -9.71694 12.1129 21.4379 +4453 4 24.5044 38.0178 17.9266 6.55828 0.975012 -4.85481 +4454 4 24.4839 37.6255 19.4009 7.37292 -12.3795 -13.3571 +4455 6 3.16023 27.7824 5.25746 -7.59771 -9.49442 8.09122 +4456 4 2.57386 27.9573 6.05068 26.7372 -11.3185 -11.6141 +4457 4 4.04718 27.3724 5.4685 -26.4098 5.90831 3.92345 +4458 6 37.1274 39.059 36.0582 -20.0626 39.3499 3.12364 +4459 4 37.4397 39.697 36.7497 0.155645 -22.9334 -11.3782 +4460 4 37.5741 38.2261 36.1006 18.9616 -13.4483 8.05827 +4461 6 41.3496 16.372 3.85306 -8.55617 -26.9153 -3.74777 +4462 4 41.2863 17.3336 3.84263 10.0449 1.9656 13.5452 +4463 4 42.0245 15.9886 4.46176 -7.16622 24.1057 -6.4954 +4464 6 15.5715 3.1806 35.3543 4.49903 -8.79025 -44.1337 +4465 4 15.0747 3.51322 34.5661 7.45265 -4.29831 20.3405 +4466 4 15.2394 3.62675 36.1076 -11.9729 17.6287 21.2524 +4467 6 33.1697 24.252 7.98021 17.4163 -35.2043 24.5175 +4468 4 33.373 24.4892 7.07941 -5.88693 14.0606 -13.9779 +4469 4 32.5854 24.8767 8.38373 -10.6809 23.5743 -3.02942 +4470 6 35.8792 29.7453 15.5891 -14.351 2.75051 -7.10357 +4471 4 36.7674 29.6271 15.8378 44.9858 5.9786 2.16229 +4472 4 35.4705 29.0828 16.1298 -19.5083 -3.35284 8.18061 +4473 6 17.5951 36.8258 41.8642 -13.8657 0.640745 -39.4401 +4474 4 18.0986 36.7885 0.752491 19.5286 0.61142 14.8967 +4475 4 18.204 36.9888 41.0995 -4.16013 -2.78766 23.3657 +4476 6 26.5622 4.14757 31.1303 -11.2209 -47.8968 -15.8259 +4477 4 27.2883 4.63526 31.456 28.856 27.2634 11.544 +4478 4 26.9475 3.23966 30.9928 -12.9924 23.1667 5.46977 +4479 6 31.9456 1.33308 34.4467 -12.9904 6.64728 -11.4505 +4480 4 32.8071 1.19449 34.8725 -11.0783 -3.65615 8.33208 +4481 4 31.1956 1.0725 35.0172 18.2758 0.413953 2.527 +4482 6 24.503 14.7492 2.38048 9.24208 -0.0712211 -0.802907 +4483 4 24.1928 14.0003 2.93847 14.4388 11.7071 -7.35684 +4484 4 25.4689 14.9243 2.53228 -19.8697 -9.93034 3.69906 +4485 6 25.7634 20.9148 27.525 0.946636 -0.977661 -1.30084 +4486 4 25.4997 20.5428 28.395 3.38508 9.32598 -11.7317 +4487 4 25.6529 21.8806 27.5755 0.284497 -3.23384 4.14496 +4488 6 18.1477 40.1511 30.6505 2.638 -12.7558 5.82509 +4489 4 18.5379 39.2542 30.773 0.361891 20.0487 -3.45439 +4490 4 18.8736 40.7943 30.5754 -0.793328 -5.73314 0.616918 +4491 6 46.8137 23.9108 24.5765 -6.45001 25.2139 -38.2053 +4492 4 46.156 24.4917 24.0674 25.2521 -23.4518 17.6745 +4493 4 47.3533 23.4819 23.8873 -7.92808 3.44465 4.72259 +4494 6 45.5993 22.6806 26.5072 -4.87261 3.12825 -8.14378 +4495 4 46.0946 22.9584 25.7273 -3.42504 -3.72677 5.16847 +4496 4 46.0209 23.1613 27.2227 -5.79148 -3.32105 5.25932 +4497 6 20.0977 4.47574 26.7104 -1.85738 36.2438 14.3308 +4498 4 20.3766 5.37803 26.4593 -10.8474 -9.08605 12.6513 +4499 4 20.6066 3.98633 26.1049 14.7704 -34.5311 -24.6657 +4500 6 35.268 26.6035 12.5547 25.3434 4.5593 25.1203 +4501 4 35.7054 25.7374 12.5354 -13.4481 2.49909 -6.64065 +4502 4 35.8431 27.0669 13.1929 -15.092 1.56141 -12.9558 +4503 6 3.25549 33.9664 12.2985 -21.2488 -6.99508 3.93395 +4504 4 2.30606 33.7392 12.3085 7.5225 -4.25393 -1.25154 +4505 4 3.25844 34.917 12.332 8.53638 16.5693 1.24934 +4506 6 36.6808 1.27299 25.5856 -28.051 -2.86161 17.5249 +4507 4 37.6164 1.46673 25.6835 8.21338 5.71919 3.59986 +4508 4 36.1703 1.6124 26.3685 15.6278 -2.9361 -18.4357 +4509 6 16.8737 4.664 24.0353 -31.9925 -2.01789 -27.2632 +4510 4 15.8786 4.73848 23.8401 40.5517 -2.65221 8.73903 +4511 4 17.2589 4.19458 23.2519 -3.48506 7.68373 17.7614 +4512 6 39.6701 15.0742 7.83356 -1.71206 -7.05123 2.14494 +4513 4 39.2725 14.2274 8.02711 2.44544 -9.24519 17.4119 +4514 4 39.3892 15.1326 6.9218 7.69265 14.011 -7.76766 +4515 6 9.96731 20.1909 2.92864 -13.1382 1.0323 -16.144 +4516 4 9.71565 20.5309 2.05786 3.65664 7.03968 6.64426 +4517 4 9.8995 19.2377 2.78093 4.24026 5.10291 12.3576 +4518 6 23.4077 4.6159 15.27 -3.48308 -16.1533 -1.5067 +4519 4 23.619 4.71624 14.3536 6.29203 -7.01184 -22.1313 +4520 4 23.1672 5.50294 15.4683 -4.33935 19.8524 20.6561 +4521 6 23.5267 41.6518 17.9122 -9.44104 0.807914 21.3506 +4522 4 23.7067 41.2659 18.7956 7.59245 -0.294373 -11.029 +4523 4 22.6339 0.0834245 18.0732 1.82991 3.48892 -13.1537 +4524 6 30.9316 4.82324 1.33107 45.9774 51.3713 7.99935 +4525 4 30.5768 4.02682 1.05687 -28.0042 -54.4029 -17.3695 +4526 4 31.8094 4.8761 0.879215 -15.6392 -0.833181 8.5221 +4527 6 29.2201 33.7587 18.5991 58.073 2.92721 -1.85527 +4528 4 30.1837 34.1183 18.6008 -42.2538 -17.2347 0.0641557 +4529 4 28.6837 34.5413 18.5643 -15.6262 17.5996 3.33909 +4530 6 23.1221 16.7099 3.68521 11.8431 -16.3115 0.0733348 +4531 4 23.6562 16.338 2.95547 -9.45134 2.67217 9.8165 +4532 4 23.048 17.6538 3.54099 -2.31098 6.59774 -1.54538 +4533 6 34.8961 26.7639 31.7325 -1.99602 4.46994 3.67284 +4534 4 35.0929 27.7139 31.562 -2.18198 -17.8875 -5.58085 +4535 4 35.0252 26.2302 30.9312 2.47742 18.1005 -1.54363 +4536 6 7.11189 40.7663 20.959 14.901 4.90705 15.7674 +4537 4 6.49418 40.4573 20.3006 -5.17655 -2.88906 -15.6427 +4538 4 7.9749 40.9101 20.5297 -6.61986 -3.78335 -7.15935 +4539 6 52.4451 9.69387 11.9379 -8.46192 -13.0679 -16.1645 +4540 4 52.1167 8.90553 11.4509 5.46474 18.3719 13.4625 +4541 4 53.1134 10.0871 11.3593 -6.16158 -0.354597 4.80602 +4542 6 12.0344 32.7576 27.7445 1.28323 7.36678 12.5499 +4543 4 11.2848 32.2741 27.3627 7.37999 2.33687 -5.47139 +4544 4 12.7987 32.654 27.1746 -1.40521 -5.62475 -4.84597 +4545 6 15.7821 18.5441 0.84801 8.76354 -4.35468 -11.8188 +4546 4 16.4439 18.9467 1.42581 -3.0166 1.81121 1.10538 +4547 4 14.9492 18.5892 1.29924 -12.8156 0.756803 9.02992 +4548 6 30.9925 13.9418 7.42386 -4.40747 -9.92517 -19.1249 +4549 4 31.0137 13.4754 6.53341 6.38174 17.9129 28.0089 +4550 4 31.6996 14.6103 7.52177 -5.32565 -11.3142 -7.68087 +4551 6 23.9405 39.5605 3.5435 10.8606 -6.43074 -8.73391 +4552 4 24.3095 38.7805 4.04208 -2.00396 18.4511 -18.0645 +4553 4 24.6123 39.8651 2.88148 -9.69774 -9.50421 15.8523 +4554 6 53.2462 13.9551 2.00337 -15.5118 -12.0942 -3.71099 +4555 4 54.104 14.269 2.28215 12.5804 5.35006 1.30654 +4556 4 53.0522 14.3304 1.13281 7.32968 -0.777694 2.32044 +4557 6 29.4483 26.4268 7.81741 -0.171572 11.4439 -18.4732 +4558 4 29.8672 26.7876 7.00927 -3.33338 -4.99995 18.6366 +4559 4 28.5088 26.3872 7.58736 -4.03891 -2.78124 5.15679 +4560 6 24.6251 23.6043 31.0935 -26.8137 17.7603 -44.4691 +4561 4 23.7139 23.2229 30.9355 29.773 11.0738 8.78977 +4562 4 24.7983 24.2076 30.2965 -2.98074 -30.8217 36.523 +4563 6 33.658 19.3188 40.511 -4.29932 4.0975 7.85681 +4564 4 33.8365 18.6271 41.1728 0.0947513 0.993086 -5.72158 +4565 4 34.3002 19.2334 39.7953 0.390848 -1.03282 -3.03706 +4566 6 0.558986 35.9852 14.2205 11.1667 11.0015 21.0521 +4567 4 1.21386 36.1432 14.9149 3.92292 -5.96876 -2.97707 +4568 4 0.043734 36.7876 14.3014 -15.3768 6.08493 -10.5247 +4569 6 7.05222 12.7587 15.7802 -26.1824 -15.4106 14.8382 +4570 4 6.35773 12.5373 16.4499 19.2033 7.53925 -13.5919 +4571 4 6.88557 12.0803 15.1093 4.12905 5.75416 0.888 +4572 6 7.8802 3.87979 22.4264 4.564 -30.6165 13.1651 +4573 4 7.61737 4.55637 21.8154 -5.12813 13.4305 -13.5146 +4574 4 7.59435 3.01808 22.0419 3.92228 16.9329 8.71162 +4575 6 50.747 32.0919 16.246 0.584829 29.9532 -6.88448 +4576 4 49.8575 31.8158 16.477 -3.66132 0.0213613 -0.234359 +4577 4 50.6533 33.048 15.9617 2.92819 -31.696 10.1835 +4578 6 15.3083 18.2099 30.0577 17.4273 -12.3999 25.5818 +4579 4 14.8795 18.523 29.2753 -13.2188 2.60124 -19.4058 +4580 4 14.9888 17.3027 30.2404 2.47215 8.3937 -6.40515 +4581 6 36.7253 25.4508 33.3862 -30.1432 30.6395 -17.6873 +4582 4 35.9871 25.9696 32.8546 42.334 -36.2451 27.5582 +4583 4 36.7428 24.5171 33.143 -7.68133 1.91065 -3.3758 +4584 6 16.5208 21.8449 20.262 -11.2097 8.64672 -3.63533 +4585 4 16.6085 20.9267 19.9682 1.68058 -0.497742 -2.90804 +4586 4 16.3112 22.3946 19.4823 4.36577 -8.59001 6.07269 +4587 6 44.2833 3.11948 30.0766 -7.99673 -6.73576 30.9987 +4588 4 44.2005 2.2232 29.7402 -0.794022 -7.70278 -4.62871 +4589 4 44.5183 3.67066 29.3503 7.77568 15.2131 -24.9404 +4590 6 51.0808 14.1269 27.7758 -27.047 -14.2895 -4.28411 +4591 4 51.175 15.071 27.7901 8.66575 19.7266 0.878182 +4592 4 50.1173 14.0309 27.5969 15.0189 -4.76366 3.10402 +4593 6 54.1497 15.8755 27.1203 10.9044 -5.07506 15.753 +4594 4 54.6247 15.0341 27.411 -19.35 18.5916 -21.6107 +4595 4 53.6213 15.8397 26.2863 11.6919 -13.2292 13.7718 +4596 6 26.7269 15.1716 34.5247 3.07047 6.28357 -2.56105 +4597 4 26.6547 16.15 34.5201 9.87746 -16.6036 -4.19036 +4598 4 27.4477 14.9176 33.917 -5.54963 13.4877 1.89491 +4599 6 34.6713 2.21044 27.481 35.3652 -9.42756 14.1603 +4600 4 34.3712 2.0217 28.3795 -9.10436 3.38048 -0.887416 +4601 4 33.9282 2.37922 26.9258 -24.4077 6.67858 -6.22498 +4602 6 36.3012 17.6491 40.388 5.86113 23.4658 6.44349 +4603 4 35.7206 17.1804 39.7974 -3.43874 -12.7236 -2.47465 +4604 4 36.6864 17.0408 41.0377 -6.22241 -0.114851 -7.42509 +4605 6 26.2819 0.194243 33.0916 -21.1162 -1.74839 5.89968 +4606 4 26.0541 0.792538 33.818 7.17118 8.51167 2.05738 +4607 4 25.4361 41.6393 33.0097 0.772233 -7.73624 -3.23605 +4608 6 5.19547 35.5715 31.6247 14.6733 -21.492 26.4929 +4609 4 6.10271 35.831 31.8735 -9.75028 2.17691 -1.53344 +4610 4 4.97694 36.0548 30.8519 -3.41417 18.4244 -29.6169 +4611 6 20.2195 22.0294 35.119 8.25657 -3.203 11.321 +4612 4 19.9286 21.1888 34.7559 -2.68712 -4.78598 1.15285 +4613 4 20.5567 21.7901 36.0152 -5.29706 4.10974 -20.8318 +4614 6 15.9087 36.5843 36.9399 0.69981 -30.9087 31.3945 +4615 4 16.5764 37.2836 37.0377 -3.33596 -3.14632 -1.27145 +4616 4 16.032 35.9777 37.754 -5.87689 21.7482 -34.0408 +4617 6 30.95 22.3912 3.57027 12.227 -51.3484 -20.5494 +4618 4 31.0645 22.6091 4.4902 1.82476 2.59415 19.1922 +4619 4 31.2691 21.4218 3.50648 -13.7255 40.3499 2.75328 +4620 6 47.0405 8.41049 14.2025 -7.26712 -13.7585 -23.7685 +4621 4 46.2225 8.31623 13.6472 18.9804 2.55096 13.7682 +4622 4 47.7321 7.85584 13.7597 -18.0416 11.4216 8.02226 +4623 6 34.1106 18.627 3.15563 -0.4946 23.1394 22.2065 +4624 4 34.672 18.2914 3.86301 0.996255 -3.71784 -4.49801 +4625 4 34.2399 18.1173 2.36738 0.542984 -13.2578 -17.3669 +4626 6 26.7976 25.3916 12.343 -23.6037 -44.5624 17.4882 +4627 4 27.2059 26.2338 12.4335 13.1462 29.8808 4.32264 +4628 4 26.6887 24.995 13.243 7.37483 11.5945 -21.6739 +4629 6 22.6215 25.7777 30.8835 17.9212 -8.3502 11.6983 +4630 4 23.3826 25.7056 31.4928 -6.70991 6.16838 -4.71983 +4631 4 22.2455 24.8881 30.8847 -4.10822 -0.13742 -3.2228 +4632 6 23.6315 9.78689 35.7599 5.48292 -2.30097 -0.625566 +4633 4 22.8113 10.2893 35.7248 -4.77612 1.7474 -0.383276 +4634 4 23.3643 8.87406 35.5171 2.31753 16.9109 3.97959 +4635 6 10.4044 36.7742 9.63922 -25.0741 -4.1625 3.51028 +4636 4 9.48479 36.4361 9.55892 17.1497 7.1291 1.06445 +4637 4 10.7029 36.9295 8.73946 3.49181 4.27039 -8.54773 +4638 6 4.00239 32.4234 25.8687 17.3833 10.7639 11.9139 +4639 4 4.35688 32.9952 25.1699 -1.7627 -0.965582 -1.95819 +4640 4 3.3252 31.8731 25.4905 -12.2764 -14.2405 -10.2138 +4641 6 29.0717 26.0252 18.6551 27.2015 -27.7815 2.54409 +4642 4 28.1485 25.9947 18.9226 -9.28828 -8.18845 2.68073 +4643 4 29.5616 25.1801 18.9271 -24.0321 31.3207 -7.4501 +4644 6 15.3034 1.33037 27.9713 -8.15532 13.2931 -1.88459 +4645 4 14.9824 0.900448 27.1643 -4.10476 8.37726 9.18093 +4646 4 14.8435 2.19317 28.1161 8.64797 -17.4448 -9.70896 +4647 6 48.6122 2.88813 22.9601 -14.0575 20.6462 10.9468 +4648 4 48.3097 2.01316 22.7294 4.97712 -8.72373 -1.92059 +4649 4 49.4728 3.0448 22.5739 5.56154 -9.57595 -10.4155 +4650 6 53.0134 0.348391 19.7218 2.72624 -2.60203 -3.14968 +4651 4 52.5877 42.0257 20.5538 -0.625041 0.289898 3.74318 +4652 4 52.305 0.305612 19.0628 -0.905041 -0.864478 -1.55308 +4653 6 1.39118 17.4858 17.9447 -8.50794 14.6458 12.7327 +4654 4 1.24353 17.4779 16.9894 -1.31782 -10.0732 -1.96873 +4655 4 1.47925 16.6123 18.3551 -1.8326 -9.29856 -10.4725 +4656 6 37.8975 19.0277 37.6053 -28.6618 15.029 -11.7184 +4657 4 36.9647 18.7897 37.7838 11.6122 1.96204 1.16191 +4658 4 38.4406 18.4447 38.1174 10.3965 -16.3488 12.6679 +4659 6 26.9855 30.3558 38.071 9.50079 1.40194 -4.36533 +4660 4 26.0886 30.216 37.7369 5.39533 7.19535 -1.12484 +4661 4 27.2954 31.2276 37.7499 -13.0308 -11.5285 -0.168161 +4662 6 20.0885 18.5747 3.04679 -6.02291 21.5949 -15.2672 +4663 4 19.9787 17.7407 3.50085 7.53739 -11.7285 12.3408 +4664 4 20.8981 19.0299 3.33477 -4.38138 -14.9723 0.744253 +4665 6 35.0861 6.94018 4.08702 3.04221 -3.62035 -0.583554 +4666 4 35.6351 7.18342 3.33325 6.4301 -2.1748 -2.62446 +4667 4 34.2564 7.39563 3.93984 -10.6534 0.652929 2.2495 +4668 6 22.2213 37.08 31.2556 -28.1532 13.1327 42.6182 +4669 4 22.1563 36.8958 30.3458 -2.68084 -5.78815 -35.014 +4670 4 21.2899 37.3194 31.5407 35.2494 -6.03647 -12.8067 +4671 6 12.3954 22.364 41.8234 21.4337 26.9075 -8.21443 +4672 4 12.9612 23.1595 41.5956 -22.2624 -27.6618 12.5485 +4673 4 11.7092 22.295 41.1522 0.74395 2.83494 0.343647 +4674 6 43.2331 30.3213 23.157 26.8689 32.5799 1.85734 +4675 4 44.1495 30.0558 22.8796 -21.7207 5.89602 6.32158 +4676 4 43.3514 31.2801 23.4416 -6.45211 -30.9956 -6.78246 +4677 6 16.5257 8.07813 16.6617 -19.4309 -12.5216 11.6481 +4678 4 16.3886 8.34983 15.7476 7.00958 2.01583 -5.14722 +4679 4 17.4107 8.32004 16.9428 8.9294 8.4681 -2.86418 +4680 6 10.0506 8.65043 31.7756 -2.39508 10.2278 -10.4865 +4681 4 10.14 7.97578 32.4103 1.95442 -36.8206 12.1998 +4682 4 10.116 9.39125 32.3649 -0.107045 27.388 0.472024 +4683 6 10.1509 6.49695 25.6483 14.6726 -6.33183 2.00995 +4684 4 9.37694 6.15153 26.0805 -12.3653 -8.75157 5.1154 +4685 4 9.82248 7.1865 25.0601 3.70088 -0.958502 2.30736 +4686 6 49.8668 7.2369 25.5225 -24.0329 9.97804 -6.35029 +4687 4 50.053 6.31696 25.3599 8.14544 -13.6468 -2.92498 +4688 4 50.6696 7.6642 25.7982 18.0374 4.82749 5.17198 +4689 6 18.4641 37.5693 33.932 -1.74635 9.46172 -1.89257 +4690 4 17.7617 38.2474 34.0853 10.1616 -18.2299 -3.47398 +4691 4 18.0542 36.6946 34.0238 -8.30855 4.53024 1.19921 +4692 6 32.1897 34.7964 39.2558 32.2313 -17.5381 13.0656 +4693 4 32.48 34.3381 40.0896 -7.23509 10.7133 -18.5379 +4694 4 31.2879 35.0284 39.3813 -31.6037 5.0658 8.82 +4695 6 49.5304 23.9104 4.45569 25.8701 3.67026 -38.321 +4696 4 49.7808 23.1947 5.01942 4.2809 -18.8946 17.0996 +4697 4 48.8132 24.3493 4.85794 -31.8244 16.1567 21.064 +4698 6 6.0606 24.4992 33.9345 -0.638471 -2.64646 7.7036 +4699 4 6.7001 23.7849 33.7997 2.17947 5.97399 -8.00372 +4700 4 5.47521 24.1274 34.6146 -0.567039 8.82042 -5.77933 +4701 6 1.71497 22.9937 24.1827 2.23241 21.1509 -1.27791 +4702 4 1.62302 23.9425 23.95 -0.486435 -10.8617 3.92094 +4703 4 0.825214 22.7289 24.4403 -5.44701 -4.12175 2.39318 +4704 6 12.4657 16.5565 32.3481 -44.3953 42.3465 -23.9812 +4705 4 13.2256 16.0186 32.4214 25.6927 -27.9273 24.4997 +4706 4 11.8347 16.6394 33.1026 23.5286 -12.3088 -0.369419 +4707 6 21.3722 37.3857 27.9432 8.33623 1.67622 30.3175 +4708 4 21.2745 37.3852 27.0022 -8.47587 6.30229 -26.1478 +4709 4 20.7646 38.0573 28.2974 0.343549 -1.37388 -6.67046 +4710 6 27.2371 40.835 28.8059 -14.5618 2.70883 26.0148 +4711 4 26.5104 41.4636 28.9519 7.17104 -1.72995 -14.6333 +4712 4 27.2442 40.3637 29.6524 5.83721 -3.62297 -8.28664 +4713 6 0.999535 21.7321 13.5318 -29.3194 4.17708 -0.571391 +4714 4 1.85706 21.6318 13.8745 50.1621 -4.04822 5.83187 +4715 4 0.493313 21.4968 14.3164 -12.4374 2.61082 -2.41507 +4716 6 22.3196 2.57547 8.74609 19.5097 -5.43411 17.7027 +4717 4 22.9517 3.10624 8.26305 13.4452 6.72454 -0.92593 +4718 4 21.5477 2.63817 8.2102 -22.9662 -0.14239 -10.9727 +4719 6 29.9886 17.8486 8.24374 -1.93571 4.49032 -2.67939 +4720 4 29.0601 17.6146 8.32603 -5.42798 -1.41354 1.1127 +4721 4 30.4131 17.4547 9.01282 4.29332 -3.23535 5.29369 +4722 6 3.62824 37.7086 25.7053 -21.3362 8.32154 -6.60892 +4723 4 4.42904 37.184 25.8405 -4.94962 -9.47676 -0.42012 +4724 4 2.83762 37.1591 25.4673 21.6133 3.65171 5.88982 +4725 6 26.7972 27.6476 36.3581 -47.4115 -5.5291 12.7506 +4726 4 26.8465 28.2624 35.6306 8.29087 8.74477 -10.4705 +4727 4 25.8218 27.6191 36.6005 30.1762 -0.597939 -6.56813 +4728 6 13.3509 25.3111 38.1214 6.90903 -15.9492 13.2692 +4729 4 13.3459 24.3911 38.4732 0.919555 17.3618 -5.73458 +4730 4 14.144 25.7168 38.5298 -8.43807 -1.25323 -5.48633 +4731 6 49.7161 27.2636 6.73274 -18.8339 5.2299 -32.7408 +4732 4 49.5935 26.3653 6.40806 5.58405 -0.645115 8.82912 +4733 4 49.2001 27.7791 6.04852 15.3529 -4.94049 26.886 +4734 6 39.7451 11.5811 10.2076 8.75523 -9.51322 -11.6408 +4735 4 40.371 10.9447 9.80262 -5.32314 14.1891 9.76509 +4736 4 39.1233 11.799 9.49079 2.50191 2.43793 7.76023 +4737 6 17.4883 24.9894 35.5591 -19.4762 1.01983 7.35275 +4738 4 17.0975 24.7887 34.694 2.72786 0.423626 1.28381 +4739 4 18.4353 24.8575 35.5073 10.004 -2.92602 -7.93295 +4740 6 45.0832 34.9807 31.8277 24.5651 -3.79623 6.38158 +4741 4 44.3095 35.5111 32.0501 -8.6141 -4.27399 -12.5931 +4742 4 44.9123 34.3632 31.1055 -12.5508 0.508806 -0.453023 +4743 6 30.2187 9.89463 31.3271 7.05348 4.55507 6.68413 +4744 4 30.4541 10.7656 30.9635 -3.12777 -8.04008 8.45875 +4745 4 30.1355 10.0083 32.293 1.90576 1.32601 -8.54322 +4746 6 32.3712 9.2149 6.61373 28.8381 -35.7198 -39.9492 +4747 4 32.1726 8.66567 5.78496 5.01502 20.0116 29.9298 +4748 4 31.5547 9.49954 6.96481 -36.3246 12.521 14.22 +4749 6 9.26959 24.9556 35.9161 1.96832 15.842 -17.2096 +4750 4 8.91298 25.4858 35.1726 -0.127744 -15.1166 11.0351 +4751 4 9.85583 25.5957 36.3463 -2.24606 -10.0757 2.02076 +4752 6 40.3298 1.49261 18.8755 10.6299 1.30292 -21.7 +4753 4 39.6194 1.80532 19.3944 -35.8146 17.5344 12.5449 +4754 4 40.7796 0.936194 19.4956 21.1502 -18.4862 6.40423 +4755 6 5.26901 10.6323 30.4328 -1.07618 -0.575959 25.8078 +4756 4 5.0059 11.4532 29.9824 1.00544 3.53991 6.4134 +4757 4 5.36238 10.8297 31.4225 -4.75078 2.46468 -31.0333 +4758 6 25.6472 11.7043 25.6564 -2.85241 -30.912 5.54365 +4759 4 25.9319 12.4737 26.1319 5.23872 14.1859 6.15637 +4760 4 25.9893 10.9537 26.204 -5.41829 19.961 -14.7301 +4761 6 21.91 20.0664 29.7913 -6.2328 1.4725 0.460556 +4762 4 22.5319 20.0532 30.5545 -13.0709 -9.05965 -9.53591 +4763 4 21.5487 19.1817 29.5606 11.8355 8.09924 7.60661 +4764 6 10.008 19.9919 34.5046 11.2891 -12.0839 -11.2138 +4765 4 9.40296 20.4589 35.0806 -5.60052 -0.834193 8.04722 +4766 4 10.0208 19.0442 34.745 -1.06298 11.667 -2.12072 +4767 6 24.6334 10.3662 12.209 5.25257 18.8662 20.0118 +4768 4 24.6941 9.47775 12.5956 1.57271 8.96717 -2.9517 +4769 4 24.9719 11.0034 12.9045 -11.2568 -27.0384 -15.8586 +4770 6 50.4496 28.283 11.5446 48.5969 7.21476 -25.6728 +4771 4 51.3012 28.7385 11.2434 -32.0883 -19.6524 11.3949 +4772 4 50.1145 28.8771 12.2081 -10.2548 6.02908 11.3498 +4773 6 13.9159 27.6234 25.0588 -25.6331 11.4059 -15.4978 +4774 4 13.5005 28.0493 25.83 5.93925 -3.01588 -8.8098 +4775 4 13.4276 28.0022 24.2718 14.6036 -12.4854 23.8457 +4776 6 46.1589 18.6653 40.4078 -23.2184 -0.389309 -10.7846 +4777 4 45.2349 18.5626 40.0761 15.1795 0.391647 5.46432 +4778 4 46.2048 19.5984 40.6658 -0.558864 -5.77386 -4.91212 +4779 6 32.4746 14.176 27.1227 -16.003 2.1806 5.505 +4780 4 31.9042 13.6172 27.6867 7.52463 5.83279 -7.70325 +4781 4 32.1655 15.0897 27.2802 4.78128 -6.53963 -2.41902 +4782 6 14.0556 36.3553 13.3828 19.8073 6.5728 22.6139 +4783 4 14.1017 37.3298 13.5875 -14.1879 -23.5484 -13.1576 +4784 4 13.3212 36.1206 12.8052 -8.41953 14.8686 -5.40295 +4785 6 1.88392 36.5802 21.9963 -4.52806 -9.18778 1.34501 +4786 4 1.78058 36.5165 22.9531 -3.13652 -1.22736 7.08711 +4787 4 2.81062 36.8013 21.8509 3.08344 1.49572 -0.20158 +4788 6 25.283 31.8665 39.7486 -0.0346121 -4.3463 21.3102 +4789 4 24.9491 32.7147 39.4474 -1.97702 6.83441 1.95234 +4790 4 25.5262 31.9404 40.7015 -5.12155 2.92558 -20.0537 +4791 6 6.47988 22.0137 1.28428 -12.6715 -7.61279 -4.66874 +4792 4 5.53909 21.8738 1.48571 10.6555 3.73696 2.93659 +4793 4 6.5727 22.8978 0.916948 1.0061 5.37498 -0.183021 +4794 6 27.6236 25.0404 4.70626 6.00578 18.2896 15.2827 +4795 4 28.5331 25.4118 4.61276 -17.9968 -6.47987 4.19831 +4796 4 27.2352 25.3966 5.54825 13.7859 -6.49357 -18.8943 +4797 6 21.6401 30.9371 41.2305 6.69834 21.9548 -27.1087 +4798 4 21.276 30.3289 41.855 -17.7491 -18.0709 13.8774 +4799 4 21.0024 31.0127 40.4783 8.64888 -5.56942 17.5854 +4800 6 32.355 18.8729 12.7674 13.4209 4.31066 2.75957 +4801 4 31.3956 18.9706 12.835 4.55688 -5.10905 -10.5867 +4802 4 32.607 18.5493 11.8826 -7.53687 3.28724 6.30822 +4803 6 35.6452 19.4617 21.1556 -9.82604 19.2175 8.60555 +4804 4 35.3405 18.5718 21.3708 -2.26659 -3.59924 -3.4629 +4805 4 34.936 20.0876 21.4701 16.8427 -19.1907 -7.36791 +4806 6 27.6904 17.9595 34.0135 2.51947 12.848 9.8691 +4807 4 28.1207 18.371 33.2456 -3.55582 0.0466306 5.59907 +4808 4 28.0719 18.4525 34.7708 -4.77519 -7.99763 -12.3529 +4809 6 34.1913 39.0308 14.8198 -32.2909 7.81486 42.3772 +4810 4 33.7378 38.3849 14.2709 2.40292 -0.641653 -5.60016 +4811 4 33.4938 39.1934 15.5434 31.6198 -1.67931 -26.5413 +4812 6 28.5078 3.47132 33.888 -4.80695 9.04662 2.15546 +4813 4 27.9441 4.2497 33.8725 -11.1427 -2.20885 -1.07295 +4814 4 29.3801 3.85895 33.8332 18.6007 -6.2612 -1.20104 +4815 6 34.9259 32.1312 6.54177 -41.0464 -12.9808 21.9467 +4816 4 34.0171 32.0297 6.98271 38.7419 4.2921 -24.6555 +4817 4 35.5211 32.1736 7.29951 5.76537 -1.35874 -3.25655 +4818 6 31.8896 6.8799 23.5232 0.89208 3.44668 5.58958 +4819 4 32.4231 6.58347 22.7679 -0.16899 1.4285 3.8543 +4820 4 32.2407 7.75715 23.7826 1.29066 -6.24882 -6.25814 +4821 6 18.8559 1.76458 0.828337 -20.5472 23.3683 -17.7838 +4822 4 18.0266 2.11952 0.42761 13.2396 -12.575 3.84382 +4823 4 19.0445 2.38904 1.53279 3.18086 -1.81057 9.578 +4824 6 26.9929 18.9294 11.856 68.8676 -4.65359 -28.5611 +4825 4 27.3133 19.7685 11.4551 -15.5879 -7.28987 7.59546 +4826 4 26.1136 18.988 12.1267 -55.7646 13.8464 15.3945 +4827 6 43.8351 11.1458 18.4443 23.0031 -19.5153 4.50837 +4828 4 43.638 10.8812 17.5537 -13.1544 4.18059 -17.1583 +4829 4 44.5589 10.5175 18.6246 -1.75483 13.9327 9.72942 +4830 6 33.4946 40.5615 37.6755 15.4013 8.76106 -9.33396 +4831 4 34.0096 40.2689 38.4502 -12.4229 -1.46966 -1.83753 +4832 4 32.5786 40.2698 37.7667 -1.95229 -4.85928 9.55413 +4833 6 15.6186 26.7023 39.419 -29.2453 -49.1617 7.39509 +4834 4 15.4971 26.9949 40.3155 1.17426 12.5786 14.7177 +4835 4 16.1446 27.3092 38.9602 29.5915 33.502 -22.8309 +4836 6 4.38071 13.8775 40.883 9.27553 -14.126 -4.37485 +4837 4 5.31782 13.6454 41.0342 -11.8393 4.50398 0.960258 +4838 4 4.04834 13.2497 40.2173 2.13772 10.7877 7.68198 +4839 6 20.1656 10.4005 38.218 10.8779 4.82467 -13.4554 +4840 4 20.4848 10.7245 37.3555 -10.2589 -5.36296 0.708096 +4841 4 20.9923 10.2607 38.6798 -1.28838 -2.71386 11.844 +4842 6 15.1666 19.24 23.8849 4.49083 -8.21488 3.46045 +4843 4 15.3253 20.1347 24.2296 -1.0797 -1.90309 -4.08137 +4844 4 15.0239 19.3391 22.9299 0.969961 5.53483 11.956 +4845 6 47.8934 28.614 15.7995 12.3109 16.1315 8.54118 +4846 4 47.9523 27.7003 15.5425 0.10403 -15.196 -3.00888 +4847 4 48.6265 28.752 16.4246 -6.57835 -5.21115 -6.70139 +4848 6 29.9259 30.9075 18.965 7.62461 4.23841 -1.37457 +4849 4 29.1117 30.4308 18.7732 -7.06282 -5.88302 -2.4339 +4850 4 29.7134 31.8391 18.8515 -2.57834 1.4724 1.74445 +4851 6 11.9338 35.8178 28.497 -7.27451 6.14295 -10.3733 +4852 4 12.5041 35.9802 29.2427 6.70347 11.4983 16.16 +4853 4 12.1847 34.9375 28.2428 -3.53576 -18.0038 -9.26428 +4854 6 29.972 37.8772 25.486 -12.1052 4.73031 -22.3992 +4855 4 30.2553 36.9663 25.6711 3.40868 8.54106 4.83275 +4856 4 30.3747 38.5051 26.0898 8.03536 -1.45294 10.6494 +4857 6 52.6584 28.1048 32.275 31.4311 4.91254 4.04956 +4858 4 52.2473 28.8547 31.8392 -9.38068 2.35947 -3.12986 +4859 4 53.5924 28.4001 32.3224 -6.05351 -9.99886 1.81474 +4860 6 37.0156 40.0823 11.982 15.2095 -8.99172 -8.52195 +4861 4 36.22 40.5624 12.1833 -15.2617 4.79593 6.40041 +4862 4 37.4101 39.8767 12.8402 0.665617 -0.484924 4.09883 +4863 6 16.6662 16.7824 36.4899 -23.6543 20.4081 -13.3107 +4864 4 16.0299 17.4889 36.7962 20.061 -22.8424 -10.9222 +4865 4 16.728 16.9177 35.5139 -3.3638 -0.555369 18.7216 +4866 6 27.9984 4.17668 38.8431 -6.8633 -1.77316 4.22536 +4867 4 28.9161 4.3061 39.1095 4.06977 1.67187 2.70396 +4868 4 28.0368 3.69267 38.0106 -3.95018 -5.40445 -5.6405 +4869 6 28.9057 0.266004 17.7212 -6.10073 29.2375 -5.44551 +4870 4 28.1786 0.88303 17.5246 8.92385 1.95552 -1.67076 +4871 4 28.4447 41.3635 17.8399 -11.0591 -30.1495 5.35559 +4872 6 22.9291 20.1009 26.2737 12.905 2.01461 18.3128 +4873 4 23.6265 20.0378 26.9508 -1.05622 -6.52034 -10.1156 +4874 4 22.4706 20.8929 26.5742 -3.00423 3.39878 -4.61403 +4875 6 49.3993 29.9017 13.433 -6.38025 27.1117 -0.919919 +4876 4 49.1201 30.8275 13.1802 1.84527 -26.9682 8.98406 +4877 4 48.7504 29.5045 14.041 1.51099 8.43883 -0.914593 +4878 6 2.44855 24.8301 7.30401 -10.5471 2.4163 20.698 +4879 4 2.41495 24.6588 8.2845 -1.1432 9.4633 -23.8545 +4880 4 1.72338 25.455 7.1058 6.30785 -9.44609 7.39061 +4881 6 30.3915 26.4508 14.3344 -6.38639 41.9339 41.7386 +4882 4 31.0669 26.3804 15.0403 -0.162406 -14.5956 -15.076 +4883 4 29.932 27.2875 14.6522 8.5071 -34.3491 -22.1885 +4884 6 27.0361 32.5047 3.13805 -13.013 14.5566 5.91638 +4885 4 26.4776 33.1542 3.63465 13.8957 -14.3888 -12.6314 +4886 4 27.3381 31.8882 3.81715 0.997102 -1.94867 -0.811892 +4887 6 34.2693 14.8073 1.28197 14.9869 -24.9335 -24.2287 +4888 4 35.1732 14.4308 1.1613 -12.3133 12.1546 9.27146 +4889 4 33.7818 14.2606 0.617478 5.51233 18.0169 18.4334 +4890 6 30.0243 8.54272 1.33127 -15.3984 1.11418 15.9731 +4891 4 29.9557 9.47917 1.12547 1.89625 5.05184 -1.94546 +4892 4 29.278 8.4251 1.95594 13.4411 -5.55834 -8.66406 +4893 6 42.5535 11.5155 27.7085 15.437 -3.44919 -13.726 +4894 4 42.3225 12.4337 27.8881 -6.79772 -1.02898 5.45325 +4895 4 41.899 10.9203 28.077 -14.0379 1.06089 7.70623 +4896 6 52.4658 39.5603 17.8381 6.64956 -28.6351 -32.0971 +4897 4 51.7413 39.7621 18.3991 -22.9429 13.2738 25.1291 +4898 4 53.1708 40.1592 17.9962 19.9289 22.995 10.0024 +4899 6 33.211 4.92827 31.629 -12.2211 32.167 9.39859 +4900 4 32.8163 5.83971 31.6275 7.84415 -21.2817 2.59476 +4901 4 32.9135 4.52627 30.8083 -0.68235 -2.18314 -5.10952 +4902 6 6.29493 15.9859 18.7482 13.6791 10.985 9.78561 +4903 4 5.93033 16.6016 19.4273 2.88753 -17.718 -13.1605 +4904 4 5.60754 15.3724 18.4768 -10.6912 0.909102 4.08099 +4905 6 8.51749 14.5386 24.6879 -5.02573 1.07483 -2.93277 +4906 4 9.38168 14.4087 25.0828 4.4136 1.3116 3.34168 +4907 4 8.20169 13.6557 24.4566 1.37146 0.850768 1.15416 +4908 6 22.6856 10.1159 32.1347 3.63858 -5.5341 -7.29103 +4909 4 22.4401 11.0127 32.2731 -27.0162 20.0988 15.0061 +4910 4 23.4682 10.3148 31.6383 25.2173 -15.197 -13.8617 +4911 6 11.2884 2.11431 14.6724 -33.0968 -7.95794 -19.898 +4912 4 10.3134 2.08073 14.4479 21.8664 -1.34414 10.3974 +4913 4 11.7152 2.30811 13.8211 9.70644 2.30495 0.939267 +4914 6 44.9099 15.5878 36.2745 25.7257 2.41581 -13.4012 +4915 4 45.0546 15.5553 35.3019 -10.2235 2.9059 20.3658 +4916 4 43.9848 15.4747 36.4307 -17.7944 -2.84066 -0.111047 +4917 6 9.72168 19.0116 31.2214 10.0341 -21.2505 -12.9994 +4918 4 10.5925 19.389 31.3727 0.996524 0.534629 3.32861 +4919 4 9.08651 19.5363 31.6795 -15.0033 12.5653 12.9482 +4920 6 51.9861 7.59179 16.6767 -2.21949 13.5197 0.492591 +4921 4 52.6037 6.8327 16.6765 -16.3843 6.63384 -16.8766 +4922 4 51.5083 7.75362 15.8118 21.6515 -16.4571 17.7861 +4923 6 31.4364 34.7816 36.4086 3.08769 21.0155 -3.2672 +4924 4 31.7704 34.8477 37.2975 8.82098 -13.2304 13.8104 +4925 4 31.3443 35.7177 36.1951 -3.32863 3.82124 -15.3061 +4926 6 4.22848 15.0876 15.3675 -15.1793 -4.71932 15.5862 +4927 4 4.10446 14.9036 16.3273 5.02277 2.80423 -15.2934 +4928 4 5.16622 15.2495 15.2447 10.6913 1.67801 0.337818 +4929 6 47.7535 20.6847 28.0297 3.73811 3.24498 -1.95167 +4930 4 47.6703 19.7739 27.6852 3.21079 12.9013 3.0329 +4931 4 48.3469 21.1738 27.4217 -9.1514 -8.95746 6.26441 +4932 6 15.7983 1.14885 24.4111 -6.64534 16.957 -16.446 +4933 4 15.3695 0.397874 24.8496 -11.2605 5.13601 -9.62176 +4934 4 15.1572 1.72115 23.8957 14.1067 -25.56 23.4483 +4935 6 34.5718 39.7067 40.0668 -5.06722 14.7699 1.92827 +4936 4 34.1159 40.1215 40.7935 -0.0189783 27.8984 7.01187 +4937 4 34.2456 38.8495 40.221 -5.22714 -44.7262 -10.8544 +4938 6 20.1936 32.176 34.4055 -22.5016 27.7868 41.3602 +4939 4 19.6673 32.7687 35.0502 14.2298 -29.0143 -30.198 +4940 4 21.0584 32.1328 34.8407 -2.28869 -2.39527 -4.5293 +4941 6 19.3074 38.5208 11.8317 17.689 14.4135 -2.63233 +4942 4 19.236 37.5914 12.0232 -0.177798 -10.0936 4.99209 +4943 4 20.0172 38.8749 12.4245 -13.7536 -7.85063 -8.99287 +4944 6 6.52955 13.5023 26.836 -16.6143 37.6784 -17.6139 +4945 4 6.084 14.0762 26.1427 18.8957 -21.2062 24.9102 +4946 4 6.49663 12.6281 26.4634 0.197125 -15.4908 -4.14034 +4947 6 23.5952 31.5638 33.3318 1.16311 -12.5666 -5.83621 +4948 4 23.0836 31.562 34.1475 0.610672 3.97154 0.891929 +4949 4 23.5328 30.6432 33.0053 1.46337 8.27478 -1.79938 +4950 6 41.0778 31.9114 16.1974 16.3032 -14.6541 -18.8682 +4951 4 41.8878 32.072 16.7344 -12.1593 -9.44827 -16.6375 +4952 4 41.2894 31.3264 15.4036 6.53327 16.9697 25.199 +4953 6 31.7476 18.8699 19.3483 9.2825 22.1595 5.37598 +4954 4 32.0642 19.7361 19.7036 -9.20895 -19.367 -8.68372 +4955 4 31.4026 18.3831 20.1168 1.10858 -0.37958 -4.48043 +4956 6 10.4875 4.12209 19.3444 6.70816 11.4672 -10.0773 +4957 4 9.70261 4.48263 18.8666 20.7562 -4.21822 -0.723312 +4958 4 11.3166 4.33216 18.8218 -27.5212 -3.06207 15.0001 +4959 6 1.37991 32.4635 19.2846 24.7257 -29.6508 -15.3303 +4960 4 1.97113 31.6954 19.1311 -3.90248 7.07021 19.3035 +4961 4 1.16609 32.6455 18.3731 -9.24935 13.5936 -9.63824 +4962 6 42.8716 16.8513 24.9892 37.8526 -21.8211 -51.5646 +4963 4 42.4398 17.6894 25.0051 -12.6784 17.6471 3.13223 +4964 4 43.4179 16.871 24.1222 -26.4831 0.994324 39.976 +4965 6 45.3183 19.1979 4.10041 6.37956 15.045 3.35342 +4966 4 46.1127 19.7887 4.04575 -15.2131 -7.48775 2.85843 +4967 4 44.6191 19.6898 4.58798 10.0124 -1.75765 -5.61527 +4968 6 29.1291 19.8804 35.7574 13.154 -41.1853 -12.3735 +4969 4 28.6049 20.2559 36.4387 -19.4183 16.2678 16.1743 +4970 4 29.3151 20.5439 35.0927 -1.78114 11.3903 -2.63997 +4971 6 31.9353 21.8377 19.6787 8.2762 14.7684 -3.54893 +4972 4 32.7301 21.8918 19.0885 -22.5823 -4.29925 15.9785 +4973 4 31.6692 22.7774 19.8195 3.83825 -20.8185 -1.08359 +4974 6 39.1936 8.26228 18.8336 -23.7578 16.4079 -2.4793 +4975 4 38.9784 7.343 18.63 -1.41923 -3.63173 -0.882922 +4976 4 38.3593 8.77699 18.6285 24.7505 -17.6369 4.60834 +4977 6 33.27 13.2649 41.2621 -10.1289 -28.0457 11.6457 +4978 4 32.3532 13.5818 41.1472 2.43324 -1.71459 -0.314725 +4979 4 33.2053 12.355 41.6729 1.3348 20.3333 -9.56947 +4980 6 5.93721 29.5458 35.7995 -7.4397 -15.3695 -5.23966 +4981 4 6.3797 30.3135 36.1022 6.42857 23.5026 12.0451 +4982 4 6.51225 29.246 35.0987 1.02237 -6.8727 -9.18458 +4983 6 13.023 34.1764 31.9266 -10.1581 -4.84889 27.419 +4984 4 13.003 33.3874 31.3637 -4.82745 -5.23795 6.11925 +4985 4 12.6053 33.9771 32.8123 10.4055 -1.49763 -26.3146 +4986 6 33.9757 21.8032 17.9969 16.1152 -19.1834 -4.43927 +4987 4 34.6651 21.0941 18.0436 -13.0194 10.1005 -1.31384 +4988 4 34.4424 22.6001 17.7557 11.611 10.6919 -5.33679 +4989 6 35.9777 41.3398 18.1614 -6.56463 -6.11943 -26.9477 +4990 4 35.8856 41.423 17.1648 6.35377 -3.40276 32.4743 +4991 4 36.5823 0.128109 18.4064 3.22136 6.47441 1.04719 +4992 6 34.856 37.6452 30.5972 -0.647303 3.94572 7.36538 +4993 4 35.2577 36.9607 30.0196 0.445186 1.06156 15.4535 +4994 4 34.8848 37.3986 31.5588 5.49281 -5.52744 -23.9922 +4995 6 25.9972 34.4216 4.68589 -10.7784 -9.94602 -21.2075 +4996 4 25.3582 34.53 5.39473 2.66172 5.48603 12.8385 +4997 4 26.8259 34.8497 4.89674 4.47855 8.12742 13.9663 +4998 6 19.0606 33.5662 1.31783 4.31184 23.0948 -29.5486 +4999 4 19.7493 33.0549 1.74461 7.17592 -5.61608 3.87291 +5000 4 19.5019 34.1007 0.592753 -8.94353 -18.7796 23.9626 +5001 6 25.2721 8.22916 8.60038 8.3672 -6.50911 13.4278 +5002 4 25.4774 8.1828 9.55838 -2.37789 7.03817 -10.0574 +5003 4 25.4001 9.14285 8.30246 -0.229164 -0.61302 1.82749 +5004 6 12.8408 19.6874 13.0432 23.1779 -10.767 -3.57874 +5005 4 11.9236 19.9359 13.0109 -16.1394 8.08564 -1.3752 +5006 4 13.3549 20.4875 12.8299 -11.6819 -5.55115 1.76181 +5007 6 53.3458 11.4322 5.81729 13.7919 -26.0181 10.511 +5008 4 53.941 11.999 6.3288 -5.2171 7.54934 -1.97002 +5009 4 52.6156 11.905 5.44666 -11.025 16.6744 -4.72885 +5010 6 9.84401 16.0447 31.1965 1.52473 25.7097 1.4485 +5011 4 9.0725 15.75 30.7245 -12.2986 -10.5074 -10.4763 +5012 4 9.76401 17.0228 31.1974 4.09395 -10.8484 3.46066 +5013 6 25.4337 20.2897 3.31222 -0.0744965 -16.6885 15.2888 +5014 4 25.4502 20.7681 4.1742 1.29774 3.58896 -22.0188 +5015 4 25.617 20.9088 2.59036 0.892976 4.59184 10.0233 +5016 6 20.7687 8.19442 15.6442 -13.8219 -45.5838 -0.24202 +5017 4 20.3131 8.5145 16.4113 -6.16339 18.6345 13.1662 +5018 4 20.3525 7.29833 15.5772 17.5129 18.5489 -8.91575 +5019 6 37.6537 8.61162 9.99803 6.38032 -10.5281 17.8344 +5020 4 37.9174 7.70722 10.2264 -2.01487 8.44182 4.78342 +5021 4 37.3414 8.51532 9.10193 -3.86116 3.7435 -6.65528 +5022 6 50.6588 4.51187 24.2729 -10.1552 -3.70856 6.87258 +5023 4 49.9071 3.88527 24.1971 13.583 4.61791 0.248303 +5024 4 51.4381 4.036 24.5943 -3.42543 -3.47462 2.6777 +5025 6 20.1632 24.8244 34.8962 -12.0105 28.899 -22.2545 +5026 4 19.9486 25.4522 34.1467 5.29317 -18.0262 19.0072 +5027 4 20.331 23.9626 34.5117 -0.31696 -10.3492 -2.27521 +5028 6 30.5785 22.522 11.2467 -2.76969 13.8933 23.9619 +5029 4 31.2526 22.1243 10.7257 13.2932 -13.8734 -17.1472 +5030 4 31.019 23.338 11.5119 -11.6942 5.7798 2.38886 +5031 6 17.322 40.803 8.03266 14.2969 -15.2802 9.14469 +5032 4 17.3696 39.9923 8.55945 -20.3131 5.85274 7.92005 +5033 4 18.1352 40.6655 7.5489 4.4024 9.10004 -19.1526 +5034 6 23.9661 41.0457 26.0803 21.1205 -0.428792 10.5169 +5035 4 24.3123 40.6207 25.2948 17.4674 -5.32369 -4.96192 +5036 4 23.0464 41.0448 25.8953 -36.0489 4.67224 4.09659 +5037 6 9.79449 25.5813 27.216 11.7002 -20.4303 -20.1428 +5038 4 10.1564 25.0129 26.491 -8.57195 17.3601 17.171 +5039 4 10.1924 25.2359 28.0288 -3.53182 0.239058 0.558234 +5040 6 35.2535 29.8267 24.7533 16.8399 6.514 6.92542 +5041 4 34.3962 29.6585 24.3475 -6.29365 6.70405 -5.90439 +5042 4 35.51 30.7547 24.57 -10.2352 -8.20594 -2.77553 +5043 6 2.14051 4.25227 10.5512 -4.35014 2.09559 7.87868 +5044 4 1.87018 4.24401 11.51 4.03105 2.56783 -22.6964 +5045 4 1.48695 4.75313 10.0317 0.0426026 -1.98947 12.7879 +5046 6 43.1755 3.92129 23.5016 -16.6861 -14.9885 0.818311 +5047 4 43.8939 4.14262 22.9078 7.68421 2.83398 -7.81803 +5048 4 42.5577 3.34913 22.9937 11.3891 7.34243 2.48813 +5049 6 18.8996 22.6297 2.43765 22.7339 -13.1014 -2.24121 +5050 4 19.79 22.181 2.40524 -25.7911 11.1615 4.63986 +5051 4 18.7139 22.8085 3.37028 4.18935 -2.21949 -1.21374 +5052 6 20.4908 18.9405 41.5599 0.284845 -17.4141 21.8797 +5053 4 20.1374 18.6064 0.533469 2.69626 22.1818 -33.2143 +5054 4 19.9839 19.6587 41.147 -4.56676 -6.01516 12.1125 +5055 6 26.4163 7.55623 29.1338 1.47231 -3.25042 -11.8229 +5056 4 25.7099 7.08251 28.6481 8.40182 7.03804 13.9135 +5057 4 27.0821 7.71224 28.4448 -4.02075 -2.1597 11.7889 +5058 6 25.6465 35.5679 33.7595 -11.9902 -19.4032 2.16293 +5059 4 26.3374 36.2384 33.6103 2.60319 -14.9989 -6.30077 +5060 4 25.8315 34.6987 33.2841 2.54327 33.8846 12.2934 +5061 6 24.8333 0.493635 8.41989 34.5336 11.5552 47.2955 +5062 4 25.5249 0.302877 9.1499 -35.8013 6.01564 -39.2036 +5063 4 24.7614 41.6068 7.91956 0.436288 -16.6888 -13.1367 +5064 6 17.008 17.3182 3.45493 -26.2706 15.7324 15.4846 +5065 4 16.2426 17.9829 3.53843 29.8189 -30.5055 4.13684 +5066 4 17.1653 16.9244 4.35506 -11.2277 16.1793 -19.3505 +5067 6 40.1827 32.1035 19.3506 13.0539 -5.95213 0.358733 +5068 4 39.8335 31.2604 19.604 -25.4023 -11.2285 12.0125 +5069 4 40.9513 31.7409 18.9215 18.5667 14.352 -9.19942 +5070 6 23.3808 26.7171 6.31746 29.0762 21.4976 14.3842 +5071 4 24.13 27.3908 6.46801 -30.1018 -19.5893 -7.69607 +5072 4 22.7349 27.0723 5.68536 3.11778 6.18165 -0.6273 +5073 6 28.6527 28.5112 1.41186 -10.6623 -30.4119 4.69741 +5074 4 28.683 29.4458 1.20631 15.125 4.74584 -7.70298 +5075 4 29.5288 28.0803 1.2704 -12.115 26.7011 1.44139 +5076 6 12.0438 6.3157 14.0384 -8.70244 -3.06108 -4.52058 +5077 4 11.2798 6.1721 13.4181 27.4537 -0.215786 8.28745 +5078 4 12.8925 6.19521 13.5554 -16.057 2.9292 1.41242 +5079 6 20.1243 33.7022 32.0954 -30.4257 7.53408 -8.19993 +5080 4 20.1371 33.1054 32.8412 7.6416 -5.80656 10.7415 +5081 4 21.0197 33.8732 31.8382 18.9224 -1.8204 -0.321518 +5082 6 12.0625 33.3632 34.5388 -0.325915 -41.4281 -23.9157 +5083 4 11.5602 33.8727 35.1697 -10.674 0.646784 10.687 +5084 4 11.6234 32.4653 34.3673 14.5179 34.5198 8.14895 +5085 6 6.00279 22.2605 25.0501 2.06163 -11.5991 79.3474 +5086 4 5.88194 22.3996 24.153 -16.4068 14.8809 -57.8418 +5087 4 5.25089 22.6367 25.5854 16.5977 -6.05374 -22.2773 +5088 6 28.8802 9.48792 11.0269 30.0757 -27.8021 5.60101 +5089 4 29.142 10.167 11.6644 -15.2392 1.2069 -12.766 +5090 4 28.0854 9.70897 10.5587 -15.7703 15.13 -3.00542 +5091 6 25.9783 31.1564 24.8742 0.212243 -23.2246 11.0271 +5092 4 26.2703 31.9474 24.4305 5.78101 9.73635 -10.8861 +5093 4 26.5948 30.4205 24.6499 -9.08002 14.2421 1.82694 +5094 6 17.4069 22.6321 26.9528 -11.8732 29.0046 13.506 +5095 4 17.1509 23.4374 27.5137 11.798 -28.7792 -23.9739 +5096 4 17.5283 21.9112 27.5803 0.671776 -8.09241 2.21186 +5097 6 30.9731 17.6144 1.64569 13.582 26.8251 31.1357 +5098 4 30.2123 17.6859 1.07719 -13.0538 -2.75682 -13.3747 +5099 4 31.0067 18.4528 2.19078 1.05257 -25.2161 -14.5596 +5100 6 35.2833 9.73343 11.2271 -16.277 -4.62114 -26.0747 +5101 4 34.627 9.45499 10.5137 29.3374 5.62349 25.4867 +5102 4 36.1567 9.37366 10.9701 -6.28276 0.375521 -3.01301 +5103 6 12.0057 10.8077 4.27601 -12.2512 -1.40581 -7.43609 +5104 4 11.4458 10.5898 5.05281 2.39288 0.24657 -15.6405 +5105 4 11.51 10.5288 3.46435 7.55978 2.35404 20.8087 +5106 6 52.9546 23.1284 7.66438 3.19212 11.9041 -9.13647 +5107 4 53.8155 23.0936 7.22037 1.72331 -6.21969 -0.472682 +5108 4 52.7997 24.0739 7.82392 -0.633169 -8.94194 3.43433 +5109 6 27.374 5.80114 23.1096 7.51778 12.7335 11.6917 +5110 4 28.1753 5.52132 23.6349 -22.415 18.9583 -13.4562 +5111 4 27.3645 6.79042 22.9959 5.3793 -33.2455 5.89418 +5112 6 22.7689 37.6996 15.5372 -5.91943 -7.67105 33.7333 +5113 4 22.8436 37.842 14.6084 2.14719 5.97904 -25.5056 +5114 4 23.2999 36.9284 15.7907 -0.822855 1.46565 -2.93441 +5115 6 30.5901 30.1355 39.7465 -8.92084 9.99629 -19.6672 +5116 4 30.0839 29.6315 39.0953 -1.54922 -9.94816 6.16305 +5117 4 30.5761 31.0154 39.3281 8.00114 -4.73058 9.29019 +5118 6 26.5152 14.8694 29.9646 3.93344 -0.205179 -3.29595 +5119 4 25.7559 15.3094 30.3103 -24.5604 12.1261 -1.41502 +5120 4 27.0839 14.9289 30.718 22.1413 -5.57177 12.178 +5121 6 9.52543 19.5487 37.4182 -4.93509 -3.75546 7.04348 +5122 4 8.56858 19.5373 37.6772 20.7537 10.8584 -9.00922 +5123 4 9.7741 20.4052 37.0166 -14.5013 -9.56436 9.93265 +5124 6 0.91928 14.8658 2.69601 -17.5095 9.99019 63.3715 +5125 4 1.47581 15.1737 2.02419 28.2707 8.36374 -43.6031 +5126 4 1.18821 15.4309 3.47389 -7.04008 -21.0896 -18.5042 +5127 6 46.427 27.1287 41.5945 43.2461 -1.33556 -25.8044 +5128 4 47.402 27.2052 41.2817 -46.4011 -2.64418 15.4668 +5129 4 46.0299 26.5803 40.8989 0.996959 5.24299 8.87294 +5130 6 47.678 23.0562 21.3872 5.44089 38.3346 6.01366 +5131 4 46.9403 23.2179 20.8133 -13.997 9.90145 -6.64011 +5132 4 47.7418 22.1285 21.385 8.56341 -43.7487 4.99103 +5133 6 39.8587 22.235 3.08723 2.37939 -15.5871 -9.21378 +5134 4 39.0088 22.2526 3.53641 -4.44104 7.43329 4.08383 +5135 4 39.9535 21.2857 2.86173 -0.917299 22.2801 6.61021 +5136 6 14.9853 14.9328 33.4647 9.90785 18.6887 5.96998 +5137 4 15.4024 15.8269 33.5858 -13.0369 -24.3412 -0.758701 +5138 4 14.5599 14.6915 34.3048 3.28451 6.61064 -6.43534 +5139 6 27.3302 11.4834 31.9317 -27.4366 -15.9755 21.8219 +5140 4 26.9982 12.0952 32.5883 -9.79098 -5.70708 8.51591 +5141 4 28.0752 11.9422 31.6406 46.9031 18.536 -28.2392 +5142 6 36.7579 7.97089 7.62034 -1.24967 -18.9477 -14.6485 +5143 4 35.954 7.42009 7.70022 6.4697 6.94413 -3.0671 +5144 4 37.4142 7.36122 7.22008 -3.07725 6.9494 1.66736 +5145 6 49.4451 9.66335 18.2174 -4.20907 -17.0946 -5.32386 +5146 4 50.1075 10.0642 17.6138 -11.2883 10.4151 20.0604 +5147 4 49.0937 10.2089 18.9473 16.8995 10.9543 -13.1485 +5148 6 27.0353 33.866 10.7555 -3.61813 20.4819 39.0174 +5149 4 27.1089 33.3944 9.9425 -11.0368 -7.55411 -28.9907 +5150 4 26.1735 34.332 10.8422 4.28798 -12.7598 -13.2634 +5151 6 11.1949 37.4624 6.84871 0.36549 -16.8746 15.3404 +5152 4 10.8648 38.3395 6.66289 0.465253 11.7734 -2.90488 +5153 4 12.1583 37.5341 6.85599 1.64848 0.115814 -1.2743 +5154 6 19.2537 19.4156 21.9114 -15.7985 8.22585 33.6704 +5155 4 18.5515 19.3251 21.2863 -16.3583 -5.26309 -15.3133 +5156 4 20.0646 19.323 21.4355 25.7859 -3.53787 -14.4318 +5157 6 54.4972 2.91444 22.5674 41.6328 11.7794 25.4635 +5158 4 54.323 3.09449 21.6644 -16.7292 4.15243 -34.296 +5159 4 0.405558 3.31869 22.7045 -24.6299 -12.807 4.19326 +5160 6 45.0583 10.8549 24.2301 5.83399 20.0221 21.0618 +5161 4 44.4296 11.5751 24.1426 -7.03973 -3.51443 -9.4179 +5162 4 45.6095 11.2138 24.9523 4.1225 -19.1196 -10.3672 +5163 6 14.387 34.402 24.7643 -0.614961 -5.50567 -8.46915 +5164 4 14.802 35.2302 25.0278 -0.621724 2.17228 4.67692 +5165 4 14.8142 34.1913 23.9221 -0.527667 -3.77388 -2.27373 +5166 6 50.586 17.557 4.30707 17.1275 -18.9627 18.6811 +5167 4 51.3126 17.9927 4.759 8.45418 -3.82203 7.11351 +5168 4 50.1863 18.2804 3.88376 -26.598 27.5468 -24.7799 +5169 6 14.9317 33.3337 34.1113 -12.3404 20.8418 56.9019 +5170 4 15.0455 32.9404 33.2912 5.44957 -23.8922 -53.334 +5171 4 14.0148 33.1563 34.3942 8.12215 6.97131 -5.23034 +5172 6 20.8706 33.5768 38.9143 15.1188 7.04694 -15.6549 +5173 4 20.7999 34.008 39.7578 -2.44584 7.66125 17.1111 +5174 4 20.3826 32.7659 38.9944 -10.1095 -18.4284 -0.973943 +5175 6 7.78494 4.73961 26.7587 18.7098 -5.63937 13.378 +5176 4 7.2181 5.0845 27.4506 -5.7435 6.37459 2.19378 +5177 4 7.246 4.75931 25.9687 -5.82922 -1.99593 -5.70414 +5178 6 9.28281 21.4851 22.3014 51.087 14.0475 -25.6174 +5179 4 8.74732 21.9732 21.6886 -31.0609 5.1079 -5.58489 +5180 4 10.1706 21.7227 21.8793 -22.1752 -18.3044 28.8298 +5181 6 20.5441 38.2146 8.8638 -2.83914 11.917 26.817 +5182 4 20.3663 38.6401 9.7626 4.81036 -21.6973 -30.7816 +5183 4 20.4013 37.2533 8.94236 -1.07384 9.24152 7.62946 +5184 6 30.1053 39.0795 30.7451 -13.6764 41.2724 28.6819 +5185 4 30.3998 39.946 31.2193 -9.10868 -42.8123 -24.766 +5186 4 29.1169 39.0706 30.8728 28.3121 -0.882933 -5.94109 +5187 6 16.0486 22.0268 24.5039 34.2787 3.60452 0.906339 +5188 4 16.7735 22.0671 23.8432 -14.3833 -3.87047 -0.289875 +5189 4 16.5419 22.3002 25.3044 -14.2176 -3.36187 3.5873 +5190 6 5.74232 29.2062 14.4594 -18.34 10.8061 -32.1404 +5191 4 6.48422 28.7094 14.7814 11.5218 -3.49899 17.506 +5192 4 5.24211 29.6259 15.1721 5.10135 -5.91064 9.04276 +5193 6 28.0673 3.08827 25.2267 -6.08854 1.42804 12.0746 +5194 4 28.6661 3.71086 24.7756 -7.19123 -0.840207 10.3279 +5195 4 27.7106 3.5203 26.0449 13.0908 -0.523763 -20.3567 +5196 6 45.9319 29.2971 31.4223 -7.33073 21.7818 28.5056 +5197 4 45.7264 28.738 30.6765 -12.0419 -4.51403 -16.7723 +5198 4 45.1872 29.9464 31.611 20.2512 -24.9239 -13.0948 +5199 6 11.2178 22.8398 36.7928 3.83605 7.6889 -19.1741 +5200 4 10.7288 23.4227 36.1801 1.54849 -6.36416 6.79315 +5201 4 12.0227 22.5824 36.3 -5.92076 -0.954096 11.0422 +5202 6 18.9236 40.1387 39.9284 -8.72712 -15.4473 12.674 +5203 4 19.137 39.1923 39.9727 -1.01676 1.76774 -7.47997 +5204 4 18.926 40.4024 40.8597 -1.95632 5.76083 -1.10583 +5205 6 23.5567 26.0801 21.2876 -20.8354 -5.58511 20.4095 +5206 4 22.8283 26.6117 20.9473 7.44123 1.31497 -7.03875 +5207 4 23.1869 25.6705 22.0991 12.7429 3.57595 -14.6326 +5208 6 16.8309 5.38685 15.8596 17.5735 -24.6285 20.3591 +5209 4 16.4468 5.29371 14.9868 -10.6119 14.9975 -0.930521 +5210 4 16.6163 6.1995 16.3389 -7.69088 7.65746 -13.895 +5211 6 12.049 26.6129 14.9962 1.83385 5.07399 -16.0821 +5212 4 11.6864 25.936 15.5307 6.55853 -24.3886 27.1256 +5213 4 11.2609 26.839 14.5085 -0.894459 16.8406 -16.785 +5214 6 14.3334 41.4222 2.37421 26.0216 21.5484 -18.2857 +5215 4 13.7051 40.9662 2.90199 -22.7144 -12.1023 21.977 +5216 4 14.3738 0.426145 2.71152 -4.41702 -11.6567 2.07407 +5217 6 50.4009 35.8582 9.31454 24.1561 17.2373 -12.1424 +5218 4 50.8168 35.8748 8.42953 -10.1576 -5.67977 3.83986 +5219 4 50.8977 36.5714 9.7704 -11.7974 -14.2445 3.10197 +5220 6 11.3695 22.6672 26.8678 6.20997 3.92483 11.2558 +5221 4 12.2048 22.3333 26.5164 -4.88328 -1.76893 -0.685046 +5222 4 10.6892 22.391 26.2565 -8.40373 -4.36232 -8.95219 +5223 6 8.45148 34.5593 21.2814 -25.9919 -59.0281 13.1791 +5224 4 8.04792 35.0446 21.9998 -0.548909 12.0582 7.93151 +5225 4 8.02348 33.6171 21.3881 27.3669 48.26 -12.6189 +5226 6 9.41918 8.68911 24.4735 -32.1109 22.232 -11.1027 +5227 4 8.45415 8.80658 24.2608 22.5553 -3.45738 3.03744 +5228 4 9.54271 9.26889 25.2379 6.1219 4.18012 4.13063 +5229 6 32.6166 22.3351 34.507 3.90791 9.0503 -27.7323 +5230 4 32.5036 23.1955 34.0662 0.599489 -5.17288 -1.28756 +5231 4 32.8196 22.6091 35.3861 6.87298 3.84758 30.2519 +5232 6 26.7427 26.1702 7.11338 18.0622 8.0778 -11.4877 +5233 4 26.0574 25.7087 7.60312 -9.51312 -3.43645 7.19196 +5234 4 26.4504 27.0916 6.97179 -2.60416 -16.0173 4.37043 +5235 6 33.9976 11.9299 3.97475 -1.16308 1.75568 6.69865 +5236 4 33.7915 11.6388 4.87314 3.4696 4.99202 0.68255 +5237 4 33.8545 12.8906 3.99294 -0.306808 -3.71184 -1.40707 +5238 6 21.4819 20.9256 37.2108 -8.76322 20.972 13.918 +5239 4 22.36 21.3309 37.2026 5.25525 -6.97128 0.105034 +5240 4 21.5739 19.9858 37.0637 7.9716 -15.2147 -3.23728 +5241 6 18.467 41.0278 0.654954 -19.554 -29.5721 -12.8619 +5242 4 17.5024 41.1258 0.530294 8.77033 6.01734 2.0842 +5243 4 18.8042 41.8885 0.845086 4.40915 26.8371 2.49279 +5244 6 41.3548 41.7118 25.1844 12.9409 14.5374 -0.392323 +5245 4 40.9222 40.8883 25.4041 -6.90081 -12.2223 3.22908 +5246 4 41.5202 41.6634 24.2378 -1.56977 -0.361026 -1.444 +5247 6 27.6369 28.1312 3.93858 39.9773 31.9241 -60.8173 +5248 4 27.7577 28.1455 2.91253 -1.05119 3.80663 52.0412 +5249 4 26.945 27.5412 4.09124 -36.8498 -31.9254 8.70709 +5250 6 18.2839 10.5111 31.4966 0.533258 -0.0130678 0.979798 +5251 4 17.4029 10.1636 31.5665 -10.6602 -13.9647 -0.00296819 +5252 4 18.1106 11.4466 31.5267 10.9856 11.4938 1.12981 +5253 6 11.3036 37.9694 14.764 4.77413 -10.0896 11.5971 +5254 4 10.7874 37.239 14.4221 -9.53089 5.23111 -9.63971 +5255 4 11.7579 37.5414 15.5118 -2.30342 16.6377 -5.07599 +5256 6 0.816524 18.1414 27.5647 20.1272 -0.3628 -0.469578 +5257 4 0.17179 17.4415 27.469 -11.396 -5.37013 -1.78049 +5258 4 1.63281 17.6507 27.785 -7.45447 11.2502 -1.88757 +5259 6 36.8008 10.7378 20.295 8.4208 9.86458 8.47872 +5260 4 36.1948 10.0642 20.0001 -9.44027 -8.16387 -5.04241 +5261 4 36.5983 10.8279 21.2363 1.65531 0.40354 2.85938 +5262 6 47.4201 25.5213 8.04394 8.74054 5.57223 -13.14 +5263 4 47.3566 25.6372 7.0634 -2.71671 -4.96685 23.4826 +5264 4 46.5708 25.2582 8.40304 -6.39129 0.734124 -5.55138 +5265 6 13.9238 35.1275 16.0037 32.5083 18.1998 3.59786 +5266 4 13.2022 34.5755 16.1957 -32.489 -30.3694 18.6715 +5267 4 13.7597 35.4303 15.121 4.25156 9.41728 -20.5426 +5268 6 29.562 35.3734 16.1776 -35.0835 -2.07929 -8.00281 +5269 4 30.2224 34.9599 16.7245 13.9673 -5.91711 9.2078 +5270 4 28.7051 34.8863 16.2926 25.5199 12.926 -4.35301 +5271 6 29.4722 25.8866 32.4187 14.354 2.72026 -23.1845 +5272 4 28.9025 25.7608 33.1796 -14.4011 -9.23541 2.43376 +5273 4 29.1922 25.3818 31.6086 -3.9853 6.0929 23.1903 +5274 6 24.1343 2.13601 25.4438 45.8363 12.8335 -27.0328 +5275 4 24.6226 2.81425 24.8647 -23.4035 -21.9591 22.2831 +5276 4 24.7019 1.32842 25.3981 -18.0817 13.4017 1.18969 +5277 6 4.54354 34.4275 19.14 11.1292 -12.0398 21.377 +5278 4 4.4735 34.5954 18.1883 -15.738 1.03246 1.7136 +5279 4 3.71635 34.4131 19.6775 9.89222 2.06937 -18.6971 +5280 6 10.1248 17.2257 14.3121 -1.66581 -5.60367 -9.60454 +5281 4 10.2583 17.5937 15.1679 8.8306 2.43924 21.0325 +5282 4 9.4989 17.8227 13.9164 -6.75609 1.38519 -13.487 +5283 6 21.4392 41.7587 34.6855 22.2624 7.769 -11.2018 +5284 4 21.5032 41.1211 35.405 -13.4071 -7.19641 7.36579 +5285 4 20.544 -0.0182627 34.3462 -4.72666 -12.2957 11.4101 +5286 6 36.1543 24.108 12.5954 -4.82194 -9.49577 -8.67068 +5287 4 35.691 23.694 13.3698 5.25066 1.62288 -23.6525 +5288 4 35.776 23.8018 11.7194 2.97337 4.42231 26.8685 +5289 6 49.5838 18.601 19.9434 7.37368 0.836531 -4.03301 +5290 4 50.0063 19.3607 19.4891 -2.40205 -12.3461 5.19746 +5291 4 50.2865 17.9356 20.0577 -3.44895 8.52353 -2.14521 +5292 6 1.26001 7.05318 14.4907 38.3056 -26.8237 -27.7837 +5293 4 1.8201 6.82299 13.6677 -23.9217 11.4061 34.9177 +5294 4 1.48256 6.35829 15.148 -4.21477 12.5307 -9.57675 +5295 6 12.7431 22.7759 31.2417 -21.5742 -17.6245 -17.2109 +5296 4 12.7068 22.0167 30.6251 -0.189583 12.5272 11.0438 +5297 4 13.6543 23.0267 31.2833 20.8009 4.17698 1.04357 +5298 6 8.18693 18.6259 27.8062 12.2535 -2.56913 -7.18349 +5299 4 8.40416 17.6764 27.919 2.05523 15.8207 -2.89848 +5300 4 8.90605 19.0032 27.258 -7.77238 -10.2714 7.52916 +5301 6 52.132 28.0244 15.3085 -5.0475 -8.46487 8.97907 +5302 4 52.2845 27.4141 14.5747 1.7297 4.34316 -0.517396 +5303 4 52.1194 28.9169 14.9336 2.1814 -6.82244 -4.33507 +5304 6 52.6909 21.916 10.0977 -8.33066 3.09691 2.06611 +5305 4 53.4463 22.3007 10.5387 10.5159 5.84972 4.87058 +5306 4 52.7807 22.2562 9.19728 -3.40401 -0.944397 -1.81328 +5307 6 22.3502 5.78024 2.67711 -1.19821 4.70475 8.9403 +5308 4 22.3462 5.61537 3.63751 1.98719 -8.03511 -7.01348 +5309 4 22.5962 4.95479 2.25163 2.53332 -12.0932 -0.158426 +5310 6 15.4205 16.2192 21.8867 5.02822 24.0999 -40.4778 +5311 4 14.4784 16.2102 22.0595 -10.022 -3.20892 10.2198 +5312 4 15.4767 16.6809 20.9929 2.09736 -16.6333 30.6862 +5313 6 28.7089 41.2927 33.91 5.52796 3.54283 5.25404 +5314 4 28.727 40.4953 34.4564 -2.79359 -2.24742 -0.170863 +5315 4 27.7951 41.4466 33.6263 4.57527 -2.88437 3.84631 +5316 6 9.01739 31.2727 18.2059 -18.1749 -3.84142 11.7815 +5317 4 8.98151 32.2312 18.3694 0.025829 -3.44513 1.18933 +5318 4 8.52849 30.7949 18.9304 13.8496 11.5721 -17.6376 +5319 6 20.5529 20.3981 18.1799 -10.2473 -3.12886 -8.71499 +5320 4 21.0329 20.6151 18.9854 0.125323 4.65459 7.73128 +5321 4 19.8496 21.0773 18.075 13.4895 -10.4913 3.92819 +5322 6 53.9703 14.7072 37.8312 5.01214 -4.5628 8.74013 +5323 4 53.4666 15.4974 37.9319 -5.56379 24.6001 14.4542 +5324 4 53.6093 14.375 37.0321 1.20033 -18.5897 -21.23 +5325 6 28.9035 15.3885 18.8586 45.4636 -15.1916 -0.680493 +5326 4 29.8469 15.0873 18.5932 -41.6456 12.1347 6.71251 +5327 4 28.9115 15.3505 19.8299 -3.5302 1.25595 -2.12016 +5328 6 2.00256 25.8212 18.9096 3.72723 11.471 14.7099 +5329 4 2.26458 26.6216 18.4327 2.14682 1.88771 -0.892997 +5330 4 1.76414 25.179 18.2501 -5.23937 -11.562 -15.1322 +5331 6 53.2507 40.704 24.2965 8.91441 12.4597 1.37217 +5332 4 53.4683 39.7911 24.0958 -2.511 -10.6834 -0.444896 +5333 4 54.079 41.1598 24.0633 -8.96863 1.63956 3.52407 +5334 6 47.5231 32.0042 22.8531 -14.3462 4.46803 -6.08063 +5335 4 47.3408 32.7709 23.4273 6.00779 -4.56073 2.25025 +5336 4 48.2766 31.5253 23.2067 4.67997 4.39959 7.43042 +5337 6 24.6197 26.1463 33.0089 -12.4366 -5.18424 3.68853 +5338 4 24.4183 25.6868 33.835 -4.3875 -0.159577 -1.83724 +5339 4 25.4547 26.5812 33.1385 10.0429 5.3772 -3.83199 +5340 6 21.3442 17.0884 39.4824 -9.75867 4.42788 -12.86 +5341 4 22.0786 16.6105 39.8509 9.0034 -0.419098 8.66004 +5342 4 20.9617 17.649 40.1682 3.71874 -0.284678 5.70811 +5343 6 11.0324 40.4486 17.0358 15.7971 -30.8577 -26.0801 +5344 4 11.6842 41.1185 17.2103 4.65986 12.9737 2.4903 +5345 4 11.491 39.8695 16.3608 -26.1319 15.9634 25.4848 +5346 6 20.3416 21.2702 39.8615 -24.9835 10.9638 22.3655 +5347 4 20.689 20.9793 39.0389 13.9219 -9.37305 -28.7546 +5348 4 21.0638 21.2843 40.4958 4.25493 1.29328 -0.298347 +5349 6 2.11091 29.6941 22.5934 -5.9509 -23.8702 -11.6938 +5350 4 1.45034 28.9715 22.5035 1.67869 13.3355 3.97539 +5351 4 2.94117 29.2559 22.3631 0.0654014 9.01208 -1.60678 +5352 6 36.7558 30.2897 35.4506 24.3729 -18.3256 16.5828 +5353 4 36.1768 30.1398 36.2224 6.47664 5.98183 -7.75951 +5354 4 37.6324 29.8684 35.7011 -26.9845 14.5763 -5.36474 +5355 6 12.9471 4.31284 37.9204 -6.90268 -11.166 6.10722 +5356 4 12.3078 3.59731 38.1765 12.7034 25.1114 3.17689 +5357 4 12.7446 5.19856 38.3152 -2.40344 -19.0082 -2.01981 +5358 6 38.3332 5.26794 18.4655 -19.3496 19.9027 -29.1997 +5359 4 37.4721 5.17942 18.8804 2.72791 -1.29988 8.64573 +5360 4 39.0241 5.01488 19.0552 15.587 -10.1496 24.0772 +5361 6 10.4858 9.23289 21.7404 -25.2332 -4.10139 2.16313 +5362 4 10.1465 9.25623 22.657 12.6022 -3.18555 -3.91704 +5363 4 11.447 9.27854 21.7188 5.40032 0.87934 7.2107 +5364 6 0.505771 41.0407 17.3245 -0.427706 37.3637 0.906459 +5365 4 1.03474 40.3115 17.5973 10.8601 -24.0642 8.3812 +5366 4 1.07952 41.8285 17.484 -10.202 -14.0113 -5.73388 +5367 6 4.10283 5.07754 6.43738 -38.2782 -14.6693 -26.7901 +5368 4 4.80956 4.44559 6.48511 17.8781 -6.62955 4.00539 +5369 4 4.33824 5.81877 6.9517 16.1672 26.1823 21.8329 +5370 6 11.4353 25.4218 0.164599 -6.84764 4.42394 -1.26617 +5371 4 11.3082 26.3017 0.56247 4.23965 -3.25035 1.30302 +5372 4 12.32 25.1006 0.40702 -4.64442 7.63092 -0.276853 +5373 6 7.41885 21.5502 8.10769 10.495 -13.722 -26.2993 +5374 4 7.61759 21.2522 7.17802 -11.0567 9.56016 28.8323 +5375 4 8.26229 21.8826 8.44859 -7.90548 -1.09713 -4.6635 +5376 6 47.5869 16.3678 25.2584 -15.0789 15.5873 -32.807 +5377 4 46.6352 16.1327 25.0388 32.9447 8.00435 6.4503 +5378 4 47.9767 16.8704 24.4584 -11.2605 -20.3751 33.7323 +5379 6 30.9209 19.4939 39.8451 -11.8548 28.7526 -24.1689 +5380 4 31.8555 19.5183 40.0202 17.1254 -10.6903 10.4692 +5381 4 30.8076 20.3562 39.3598 -8.87252 -26.4956 11.5622 +5382 6 20.3775 24.0331 39.393 16.2123 32.2964 -6.62361 +5383 4 19.46 24.2872 39.3788 -17.3162 -0.971439 2.40317 +5384 4 20.4139 23.0995 39.5119 -7.32592 -29.4126 2.4841 +5385 6 45.906 21.2665 41.1719 -24.2736 -11.4825 -0.885762 +5386 4 46.5804 21.1569 41.8486 15.7955 10.6383 -1.5802 +5387 4 46.0859 21.9477 40.5132 15.7742 6.36757 6.57249 +5388 6 32.5682 28.1996 30.46 3.6658 -10.99 6.0107 +5389 4 32.938 27.299 30.6104 -6.7941 21.8776 -2.09353 +5390 4 33.2105 28.8285 30.8344 -2.85996 -8.65293 -4.24176 +5391 6 18.0144 1.30598 27.0418 -16.6632 -1.71712 -0.445992 +5392 4 17.1007 1.69106 27.0468 26.0213 -5.17059 4.63351 +5393 4 18.4653 1.60291 27.8546 -9.34219 2.14994 -8.02835 +5394 6 39.3706 24.9704 21.8707 -3.8719 -7.6304 -3.05608 +5395 4 39.4638 25.9303 22.0078 -2.06007 -5.24545 2.56571 +5396 4 38.5004 24.7369 22.2528 8.08795 9.92494 -4.1564 +5397 6 33.5838 21.3134 22.0984 8.18441 -4.13225 6.82001 +5398 4 32.7138 21.3502 21.682 2.4933 6.37883 -5.99313 +5399 4 34.1113 22.092 21.8324 -12.1677 -4.37971 -1.53996 +5400 6 40.113 14.9986 15.7558 -14.3933 -54.3129 -47.4443 +5401 4 39.335 14.6192 15.2293 31.4969 18.6384 20.9479 +5402 4 39.7901 15.7154 16.2477 -17.7573 36.9578 24.811 +5403 6 32.6916 17.9228 6.36161 -9.89813 9.73379 -21.0853 +5404 4 32.6423 17.3002 7.0662 1.70901 -17.6566 26.5232 +5405 4 32.2464 17.4542 5.63975 -0.790726 3.03073 -5.51736 +5406 6 50.4678 15.9334 31.144 -39.7004 -26.5385 31.9374 +5407 4 51.253 16.1743 30.7093 39.9028 11.8107 -24.2063 +5408 4 50.5343 14.9829 31.3801 -1.18751 16.0768 -7.78774 +5409 6 23.825 29.3336 31.6412 17.8706 -6.79638 -8.14744 +5410 4 23.7507 29.695 30.7549 -4.03414 2.57591 0.878238 +5411 4 24.7016 28.8907 31.6365 -14.4802 6.46497 6.02506 +5412 6 25.0497 41.6479 38.28 3.49637 2.98657 -6.73496 +5413 4 25.6848 41.2957 37.6072 -14.3525 10.6226 12.6055 +5414 4 24.5759 0.544247 37.957 10.7828 -14.7666 -1.7986 +5415 6 14.3338 25.4719 8.00129 -34.0608 -17.9542 9.33499 +5416 4 15.0375 25.807 7.49197 32.7442 17.1809 -19.3974 +5417 4 13.7504 25.049 7.33286 9.67269 6.09785 11.4563 +5418 6 17.2157 20.7463 5.33337 -33.6161 12.1619 46.6806 +5419 4 17.4746 20.2104 4.61987 19.6997 -12.8632 -39.6831 +5420 4 17.6039 21.6267 5.33982 9.69266 2.06371 -12.0346 +5421 6 18.8632 10.9532 23.7128 -6.45661 -28.7698 -18.1749 +5422 4 18.5024 10.4645 22.9505 4.54871 -4.25462 9.96764 +5423 4 18.7195 11.8343 23.4273 2.43458 32.1183 3.28403 +5424 6 7.79185 41.3929 11.0465 3.42517 6.73563 9.75028 +5425 4 8.03468 40.5075 11.3396 -5.29569 0.405018 -3.04036 +5426 4 8.54504 0.0288503 11.3371 -5.83581 0.184768 -2.76634 +5427 6 48.7029 23.1861 34.0656 -21.7207 -4.36764 -18.9996 +5428 4 48.0685 22.9631 33.3267 17.6914 7.49561 22.5851 +5429 4 49.5647 23.2306 33.645 9.38657 -0.0360042 -3.96825 +5430 6 53.7171 23.5593 15.3279 7.98903 18.1369 9.52531 +5431 4 53.9889 24.0987 14.5512 -16.5338 -16.4319 -0.0123194 +5432 4 53.1679 22.8017 15.1046 0.0193492 2.24596 -12.2178 +5433 6 22.2331 5.62812 9.84443 -1.57081 2.06392 2.32933 +5434 4 21.8309 4.81719 9.48029 9.17546 11.008 0.0652314 +5435 4 22.6135 6.1669 9.11622 -10.9942 -17.7486 8.8339 +5436 6 33.6597 8.39756 9.07438 12.888 -3.30103 7.28088 +5437 4 32.9598 8.97334 9.38893 -12.3292 7.33717 0.65351 +5438 4 33.4682 8.16911 8.16186 -5.09418 6.09353 -6.44604 +5439 6 47.3119 37.7194 20.3363 21.5156 22.744 3.03657 +5440 4 47.6473 37.5407 19.4464 -9.46862 -8.33692 4.35957 +5441 4 46.6883 37.0359 20.5464 -12.6113 -19.4741 -3.99141 +5442 6 30.8566 16.7294 10.6197 -45.1927 -36.7422 15.3603 +5443 4 30.4293 17.2093 11.3782 10.0419 -7.15869 -15.9692 +5444 4 30.3248 15.8445 10.5087 28.8517 44.18 3.4025 +5445 6 48.1145 27.7388 10.1259 3.61398 12.7601 13.975 +5446 4 49.0121 27.5791 10.4269 8.16567 7.74751 7.8449 +5447 4 47.9875 27.049 9.49259 -14.0608 -13.1923 -17.2023 +5448 6 27.3333 38.6223 25.6028 2.23096 -19.4823 3.9502 +5449 4 28.2552 38.3493 25.5855 1.31221 -11.4567 4.08925 +5450 4 27.4115 39.4856 25.2253 -6.51803 21.9055 -3.11379 +5451 6 33.3641 5.73966 21.4502 -17.8674 16.1521 -18.7045 +5452 4 32.7333 6.1391 20.8022 11.3762 -13.0233 18.1576 +5453 4 34.2053 6.04196 21.1266 17.0109 2.35293 -3.511 +5454 6 25.3113 5.14231 4.52483 0.627568 -0.448638 -4.7772 +5455 4 25.9311 5.01166 5.26368 -5.83567 -1.85096 0.781095 +5456 4 24.4169 4.85751 4.79359 12.9854 0.158453 3.02285 +5457 6 40.4761 35.641 19.148 -1.79116 -1.08437 4.96155 +5458 4 40.617 35.2798 20.0294 1.97887 -12.6912 2.42284 +5459 4 40.4316 36.5735 19.3404 -1.08207 12.5153 -8.94186 +5460 6 49.6577 30.6259 19.0198 10.1565 -2.14928 -32.2041 +5461 4 49.9169 29.8714 18.4657 1.24638 0.0316256 -4.24874 +5462 4 49.4705 30.2089 19.8368 -7.31172 -12.6811 36.7039 +5463 6 42.1447 28.3235 17.0346 32.2065 -21.7575 -5.76428 +5464 4 41.8825 28.1658 16.1189 -9.06503 7.62036 -2.3435 +5465 4 42.9622 27.7534 17.0825 -24.1402 18.2728 2.552 +5466 6 47.7039 24.5139 36.3396 16.4403 6.39896 -6.79461 +5467 4 46.9537 23.9582 36.5487 -4.01092 -10.0931 -4.11437 +5468 4 48.0889 24.2445 35.4833 -10.0455 -7.86437 4.89019 +5469 6 19.3463 26.9837 19.8062 -14.9609 -0.640093 12.1457 +5470 4 19.5138 26.0435 19.7544 7.81166 -12.6546 -12.1749 +5471 4 18.7209 27.0489 20.5386 2.91516 7.38851 -4.99075 +5472 6 47.0534 26.8134 37.524 14.5946 -27.4581 20.3182 +5473 4 46.5999 27.4025 36.9765 -27.9132 42.868 -22.1392 +5474 4 47.3287 26.1433 36.896 5.92816 -9.16339 3.59921 +5475 6 9.30604 24.6864 40.2824 32.5721 -4.72803 4.84631 +5476 4 9.7425 23.8424 39.9878 -14.1318 19.2209 8.44319 +5477 4 10.0514 25.1942 40.7028 -19.8613 -12.5192 -10.8686 +5478 6 14.4861 17.9115 14.2864 12.9549 -2.10551 -8.28408 +5479 4 13.7677 18.2592 13.7435 1.92348 1.2648 2.86628 +5480 4 15.2633 17.8567 13.6783 -18.4643 2.67645 15.1406 +5481 6 37.1346 38.6824 18.7128 7.24689 -5.58535 -9.53541 +5482 4 36.7159 39.5508 18.578 6.84706 -0.690413 -9.37485 +5483 4 37.7177 38.457 17.9456 -10.6272 10.0511 7.65618 +5484 6 11.4119 5.91281 21.4549 8.51563 -6.63227 17.2429 +5485 4 12.0074 5.45436 22.0841 -12.0343 5.82261 -11.8758 +5486 4 10.9825 5.24051 20.9122 -1.087 -4.70833 -2.40093 +5487 6 4.25375 30.708 16.2346 29.3973 -34.9884 0.269827 +5488 4 4.09384 31.4404 15.6668 -11.3131 25.7038 -10.6546 +5489 4 3.7498 30.7826 17.0293 -13.4231 7.50595 13.7704 +5490 6 17.6719 16.0027 27.067 -23.8279 -26.0778 -36.6424 +5491 4 17.4271 15.046 26.968 10.0078 22.1048 9.82572 +5492 4 17.2008 16.3672 26.2667 15.5193 1.39518 21.9495 +5493 6 36.5109 8.65039 40.4308 12.8187 7.82554 4.51092 +5494 4 36.6212 9.57953 40.6523 1.70353 1.63484 0.0365135 +5495 4 35.6422 8.38915 40.7323 -7.59123 -4.26386 -1.28756 +5496 6 13.6114 12.9582 3.02589 -9.62347 -2.84414 10.0553 +5497 4 13.2363 12.4097 3.76862 19.3807 16.1747 -17.4749 +5498 4 14.4444 13.4268 3.2396 -7.87441 -9.64772 8.81761 +5499 6 38.5595 20.1494 21.6232 12.4359 -2.6335 16.4863 +5500 4 39.2259 20.3435 20.9591 -1.48691 0.443177 -6.45697 +5501 4 37.7118 20.0829 21.2013 -17.1516 -4.14152 -12.2545 +5502 6 50.9933 10.2578 30.842 -13.0607 -20.693 1.71035 +5503 4 51.4592 11.0512 30.6346 13.219 20.5706 -0.472754 +5504 4 50.4501 10.1493 30.0523 -4.00654 -4.85851 -2.78428 +5505 6 16.2749 2.41767 41.3132 30.43 46.2693 -10.4997 +5506 4 15.891 1.63581 41.6436 -18.412 -43.9133 0.0464609 +5507 4 16.2795 2.47169 40.3396 -9.09423 -14.5759 6.47164 +5508 6 16.5834 4.98938 41.8776 -7.21709 18.0228 -35.1788 +5509 4 16.7462 5.00964 0.881122 10.2158 10.5242 44.5139 +5510 4 16.3516 4.0781 41.7536 -3.71457 -12.9135 -9.58407 +5511 6 38.2173 37.6461 20.9885 34.7311 9.53448 3.02785 +5512 4 38.1039 38.1836 20.1861 -3.89758 -6.06348 6.62032 +5513 4 39.1638 37.7895 21.271 -30.6928 -4.57838 -6.40603 +5514 6 27.3006 1.89931 15.7822 -29.9599 0.296682 7.03709 +5515 4 27.5073 1.31215 15.0574 1.93116 -3.76907 -9.96281 +5516 4 26.3073 1.90747 15.8082 23.9237 -0.0762349 1.33551 +5517 6 29.0265 12.4386 37.8107 0.525722 -10.271 3.33822 +5518 4 29.5022 13.2884 37.7591 0.646351 -6.15481 8.15455 +5519 4 29.2991 11.9227 38.6151 -0.523918 21.8031 -11.8471 +5520 6 46.0742 20.1649 18.9021 10.3528 7.89056 -10.7305 +5521 4 45.1842 20.5502 18.8696 3.90233 0.901411 -3.14496 +5522 4 46.6469 20.7119 18.3183 -8.66547 -7.99067 8.59505 +5523 6 2.04022 38.6829 18.5084 -2.98341 9.82285 -40.3455 +5524 4 2.90324 38.7749 18.9245 -0.612017 -3.29975 20.9344 +5525 4 1.3228 38.3823 19.0758 6.43327 -3.78011 20.6074 +5526 6 44.0503 24.9822 25.9794 4.67294 -4.59524 3.88497 +5527 4 44.3373 24.0607 26.0767 4.76241 4.2408 6.41339 +5528 4 43.5759 24.9717 25.1449 -4.92835 3.44315 -2.97359 +5529 6 5.98031 26.6293 4.53551 9.30387 5.64625 14.1271 +5530 4 6.57491 27.1353 5.14729 -11.3776 -17.0368 -12.135 +5531 4 6.21313 25.677 4.5841 -4.82905 19.4284 -2.02229 +5532 6 0.0924267 23.2133 10.9333 1.42961 0.53672 3.80218 +5533 4 0.717354 23.7388 10.4004 2.9288 -9.65077 10.1872 +5534 4 0.580921 22.6863 11.5989 -3.01683 9.30052 -9.37626 +5535 6 39.1222 20.6154 12.8741 28.3348 2.95161 0.461931 +5536 4 40.0468 20.8249 13.1753 -23.4009 -9.33487 -2.82098 +5537 4 38.9932 21.1408 12.0685 -0.0080483 -0.226832 2.68059 +5538 6 39.959 39.9495 18.871 8.01281 1.93571 -21.8826 +5539 4 39.6441 40.4313 18.0693 6.09748 -11.7745 18.4856 +5540 4 39.3412 40.1359 19.5607 -16.2687 5.42221 11.8382 +5541 6 49.288 23.0046 30.5128 21.2206 -9.75551 18.5897 +5542 4 49.5389 23.7528 30.0013 -1.98497 24.1116 -29.9204 +5543 4 49.9896 23.0569 31.1809 -5.40626 -11.587 6.30696 +5544 6 10.3545 2.34292 9.14765 -20.562 40.259 12.8074 +5545 4 10.1012 1.5797 8.68555 -3.02669 -36.876 -18.9145 +5546 4 9.58966 2.94108 8.9894 20.4134 -0.423974 9.05106 +5547 6 9.6115 40.9317 19.7379 12.0905 -27.6191 -4.08509 +5548 4 9.69139 40.7751 18.7589 3.32448 -0.840478 24.839 +5549 4 9.96472 40.0953 20.2033 -15.7711 32.9781 -27.126 +5550 6 29.2535 5.10379 17.4957 6.62295 15.7752 6.05206 +5551 4 28.9547 4.7998 16.6324 -1.76299 0.290572 -5.22762 +5552 4 29.5626 6.02275 17.3534 -3.29284 -14.1281 1.20249 +5553 6 27.0956 15.411 3.22262 8.43004 -47.4217 3.28637 +5554 4 27.2677 16.3043 3.38591 1.16524 52.1129 6.18754 +5555 4 27.741 14.9724 3.82188 -13.792 3.46242 -10.72 +5556 6 32.8341 39.3821 25.1177 -1.66938 -44.1854 21.376 +5557 4 32.6253 40.2767 24.9331 -7.27917 31.8978 1.68524 +5558 4 32.4689 39.1753 26.0219 6.68592 11.3878 -26.9617 +5559 6 34.9613 7.8883 31.2358 4.6626 36.0744 6.61898 +5560 4 34.1778 8.39814 31.5057 7.62156 3.23778 -2.6687 +5561 4 34.6431 7.01199 31.2355 -6.57887 -35.8668 -2.78431 +5562 6 6.13276 36.7597 26.1434 10.8988 16.6869 20.3463 +5563 4 6.63888 37.4372 26.6797 -12.2659 -21.448 -21.9021 +5564 4 6.61066 36.5785 25.3331 5.0666 0.722926 -2.43587 +5565 6 6.00975 25.8323 24.1014 -4.47961 0.932019 -2.36624 +5566 4 6.35352 25.3647 24.9068 -18.3984 14.8695 -13.0656 +5567 4 5.16189 26.3111 24.2876 18.65 -15.8322 7.58859 +5568 6 45.6302 24.3945 2.56021 19.8484 -5.54431 -0.0961329 +5569 4 46.4674 24.0527 2.19931 -2.34639 0.0383291 -2.49188 +5570 4 45.6784 24.1611 3.48508 -4.52597 -1.56916 11.2469 +5571 6 15.5147 11.7041 32.683 14.9804 20.126 19.7749 +5572 4 15.7333 12.537 33.1619 -4.31998 -20.325 -9.45866 +5573 4 14.9494 12.0119 31.9786 -9.0483 1.88099 -11.1618 +5574 6 46.4109 17.7015 37.4781 -27.0258 -32.7931 -28.9932 +5575 4 46.5427 17.8951 38.3867 3.19976 6.65122 29.0636 +5576 4 45.8763 16.8534 37.4192 15.4316 28.8096 -0.764517 +5577 6 39.7197 20.9143 18.534 -24.0731 20.2285 32.8184 +5578 4 40.3775 20.5463 17.9571 20.7324 -0.0260386 -6.5243 +5579 4 40.0771 21.5962 19.1648 -0.0511872 -19.8333 -22.8182 +5580 6 23.8035 28.041 36.6748 9.0016 14.1447 -6.24075 +5581 4 23.3139 27.2938 37.064 2.44252 16.2828 7.25552 +5582 4 23.789 28.845 37.2599 -7.88527 -27.7019 -2.97202 +5583 6 23.2344 0.634844 30.8976 -0.384503 -14.0448 -5.97485 +5584 4 23.3889 41.8653 31.5825 6.30765 2.44689 -9.38002 +5585 4 23.8441 0.49945 30.133 -8.72578 -2.57312 14.648 +5586 6 37.1436 6.89172 28.2858 -3.37167 6.44507 30.6351 +5587 4 36.8056 6.23733 28.9583 11.2574 17.9183 -21.3683 +5588 4 37.4325 7.68669 28.8192 -8.94015 -21.4647 -17.7418 +5589 6 3.23535 6.60909 12.3935 -1.87368 1.73448 8.36027 +5590 4 3.03832 6.9284 11.4867 8.20532 -9.84476 7.71099 +5591 4 3.52123 5.67427 12.3822 -6.77188 11.8795 -6.70084 +5592 6 12.6173 19.1518 31.1213 -5.69854 -18.2223 8.29425 +5593 4 12.5903 18.2248 31.5183 -0.203161 27.8336 -18.7857 +5594 4 12.2771 19.1425 30.2049 2.23067 -5.60852 14.6148 +5595 6 15.1884 38.3149 41.5578 -3.57026 -0.303434 0.776802 +5596 4 15.4085 38.7623 40.7331 -1.55695 3.41656 0.7558 +5597 4 16.0064 37.8692 41.7958 4.70682 -3.66196 2.37744 +5598 6 49.6308 33.3399 19.6427 -23.754 -26.2674 -4.71234 +5599 4 48.6425 33.4171 19.8493 35.7001 -9.4047 -10.4581 +5600 4 49.8006 32.395 19.3286 -9.63678 35.3831 11.1391 +5601 6 6.36026 2.78098 29.8944 3.74937 13.951 -9.77631 +5602 4 6.39713 3.75696 29.8119 -0.635871 -14.0149 2.80012 +5603 4 6.09114 2.63212 30.8044 -1.55083 -4.44243 9.60337 +5604 6 13.1715 31.7798 30.2783 -11.6407 3.9064 -21.9894 +5605 4 12.793 31.9725 29.3819 8.72012 -0.590438 18.6573 +5606 4 12.9685 30.8401 30.4245 2.82441 5.28785 4.26217 +5607 6 32.3245 32.246 24.8932 -0.334642 -17.4514 3.51608 +5608 4 32.5833 31.3985 24.4266 1.55373 29.7789 3.70352 +5609 4 32.7413 33.0821 24.5914 4.2936 -14.9539 -9.40787 +5610 6 41.9919 14.5701 37.4124 -31.8928 -38.2057 -11.1184 +5611 4 41.1925 13.9916 37.278 11.7187 28.3557 2.93562 +5612 4 42.6351 13.8531 37.4242 20.2579 6.94588 1.70752 +5613 6 11.8923 7.24234 27.6655 -13.1666 -25.4093 6.94854 +5614 4 11.7936 6.42612 28.2118 8.91213 18.8361 -2.40188 +5615 4 11.255 7.06027 26.9538 4.64331 9.73453 -0.841263 +5616 6 14.1973 37.538 6.88791 4.07782 -38.2298 -28.3639 +5617 4 14.4575 38.4426 6.80778 6.05638 30.4198 1.96843 +5618 4 14.5936 37.1092 6.07523 -12.6749 10.0326 27.426 +5619 6 14.2479 30.6948 36.0545 7.37408 36.4971 9.0133 +5620 4 14.3981 30.7629 35.1101 2.39159 -10.6067 -11.9788 +5621 4 14.1779 29.7876 36.2972 -1.09854 -35.7585 -0.14866 +5622 6 16.4334 33.6494 5.49228 -9.96541 -28.1856 -5.39099 +5623 4 16.7983 34.5397 5.45321 9.37649 -3.55324 -12.1003 +5624 4 16.7788 32.9912 4.81355 -0.655183 31.9156 12.6517 +5625 6 23.0317 17.1547 7.8473 13.6053 -0.132883 9.10362 +5626 4 22.1841 17.362 7.40272 9.91908 10.567 10.3381 +5627 4 23.4804 17.9296 8.30446 -24.7767 -19.3244 -18.4116 +5628 6 51.7425 20.8913 27.7088 32.6403 -5.30395 6.54704 +5629 4 51.4526 20.615 28.6066 9.31531 5.01366 -13.1678 +5630 4 52.7523 20.9899 27.7096 -40.0215 -4.95426 2.55021 +5631 6 2.19474 27.6072 28.8013 -23.9703 3.8216 12.4498 +5632 4 2.89306 28.2617 29.0045 8.22653 -14.998 -10.5048 +5633 4 2.42593 26.8662 28.2089 10.4722 10.3682 5.46115 +5634 6 17.2069 14.3387 7.70681 0.210359 -30.5014 22.2216 +5635 4 16.8342 14.1932 8.62484 13.2745 1.87397 -27.442 +5636 4 17.791 13.5503 7.49447 -17.8498 26.4292 5.4189 +5637 6 12.462 8.93964 14.7065 0.798528 8.71873 -6.67623 +5638 4 12.2438 7.98523 14.5568 11.6803 11.8078 17.0064 +5639 4 13.0577 9.12873 15.4809 -12.5262 -17.6243 -12.8578 +5640 6 42.4139 38.0579 9.76413 -20.5008 17.2265 16.0611 +5641 4 43.2035 37.8944 10.2554 20.3834 -6.45835 6.72371 +5642 4 41.8905 38.6035 10.3913 3.31942 -7.4886 -15.3201 +5643 6 51.8227 30.3513 28.272 -27.6927 -20.9124 31.2363 +5644 4 51.4089 31.1514 27.9711 0.163888 16.7369 -10.597 +5645 4 52.6546 30.2313 27.8441 24.1641 3.9866 -16.3823 +5646 6 0.181148 18.531 4.58976 -5.95747 22.8787 14.3331 +5647 4 0.30783 18.164 3.72574 1.94264 -10.8238 -19.8991 +5648 4 0.385506 17.861 5.23812 2.38695 -15.8688 4.81738 +5649 6 34.1492 0.61754 2.99129 -49.6439 4.42439 -16.0687 +5650 4 33.2398 0.938351 2.63038 43.5613 -10.8791 15.5023 +5651 4 34.8325 1.13587 2.566 3.67212 10.3309 -6.27046 +5652 6 49.171 17.2374 23.1529 12.6877 -22.0026 -17.2704 +5653 4 50.1002 17.5391 23.0823 -12.4494 -3.65532 2.68691 +5654 4 49.1558 16.3609 22.6932 2.16788 22.8154 9.36775 +5655 6 23.1488 6.5083 23.6124 -20.5997 37.6057 -45.0229 +5656 4 23.0491 7.12001 22.8007 18.1878 -21.95 27.0503 +5657 4 22.2316 6.45775 23.8939 -1.28085 -6.53623 13.7239 +5658 6 11.0806 24.0842 29.2705 -8.73998 -10.3514 -18.9502 +5659 4 11.2441 23.4599 28.5168 0.0150655 10.4905 16.9308 +5660 4 11.7296 23.9083 29.9561 7.87164 -2.5542 2.12029 +5661 6 36.5429 4.08242 21.672 0.786556 -8.94696 -15.3954 +5662 4 36.4501 4.49554 22.5359 -3.35109 8.47972 1.84417 +5663 4 36.356 4.76727 20.9996 1.47044 -5.20042 11.1851 +5664 6 31.3053 25.6355 24.591 -3.66138 3.71718 3.54675 +5665 4 31.1335 26.2845 25.3159 5.93159 -20.4343 -13.8963 +5666 4 32.0778 25.0682 24.8002 -7.66178 11.3294 7.22687 +5667 6 42.6065 23.0403 14.7613 -16.8309 4.03618 -45.3098 +5668 4 42.9655 23.4598 13.9577 -8.276 -4.36486 -1.00498 +5669 4 43.204 23.3098 15.4118 29.6291 10.3091 46.448 +5670 6 14.3159 11.6727 8.8813 -14.5655 -17.9373 -12.2817 +5671 4 13.3434 11.4421 8.85146 29.9821 6.96631 -2.22077 +5672 4 14.7728 10.9717 8.34565 -11.3371 15.3318 14.175 +5673 6 21.498 2.14139 3.39648 14.7702 -17.8734 -6.06988 +5674 4 22.405 2.21099 3.73647 -11.0312 3.8274 -0.37696 +5675 4 21.4855 1.24815 2.9799 -4.51333 14.3419 9.54204 +5676 6 22.4606 27.6741 39.0725 -9.38699 -8.57051 -12.0691 +5677 4 22.9487 28.2157 39.6788 9.87489 12.9386 7.45564 +5678 4 22.251 26.9021 39.5804 -3.7481 -10.0177 3.53978 +5679 6 37.2705 33.4961 30.0614 -4.9469 -17.1986 11.1636 +5680 4 36.5019 32.9393 30.3108 14.0133 8.69925 -1.52787 +5681 4 38.0636 33.0902 30.4641 -13.5236 2.40347 -6.71067 +5682 6 41.8394 20.8621 40.0097 -20.8091 -17.9415 -11.9484 +5683 4 40.8821 20.7467 40.2088 17.4772 5.45688 -4.89215 +5684 4 42.2425 21.2111 40.795 8.11745 4.61319 15.3924 +5685 6 10.0509 31.1054 22.2556 20.3961 -18.8014 17.2446 +5686 4 9.98499 30.8639 23.2007 -4.95143 3.66172 -13.3958 +5687 4 9.23459 31.4918 21.9926 -24.2979 8.76968 -3.95477 +5688 6 24.2243 35.3747 6.62617 -9.42531 -3.96828 -6.7527 +5689 4 23.2865 35.2144 6.56466 -9.91939 -6.68958 -24.4488 +5690 4 24.2401 35.6133 7.54088 22.4532 10.3619 17.5563 +5691 6 54.2249 13.3694 18.759 -24.737 -0.349871 -1.41807 +5692 4 53.5933 13.3703 18.006 15.3609 1.78219 9.05355 +5693 4 53.6566 13.499 19.5435 10.7967 -0.400371 -8.89572 +5694 6 12.4855 25.1013 17.4456 -6.57337 13.5018 5.68311 +5695 4 11.9686 25.7405 17.9864 9.67417 -13.0798 -6.23069 +5696 4 12.9177 24.4729 18.0482 -8.67745 6.31928 -4.55572 +5697 6 22.3956 33.969 18.8874 -5.8063 -1.6479 -7.81353 +5698 4 22.8035 34.4497 18.1359 -8.0332 -6.19684 5.18696 +5699 4 21.6693 33.408 18.5182 22.6878 13.045 2.20471 +5700 6 24.4435 12.9292 5.84415 8.74588 -19.8564 16.0901 +5701 4 24.6262 13.8512 5.99703 -0.326218 20.1414 -4.57271 +5702 4 23.8078 12.8376 5.13214 -2.90401 5.95194 -4.82348 +5703 6 13.3959 11.2335 28.6038 -6.74888 -5.61354 -5.54718 +5704 4 13.7674 10.4842 28.0847 -9.93712 8.82772 12.9583 +5705 4 12.6218 10.8864 29.0903 8.08376 -4.51111 -11.0518 +5706 6 20.9645 34.7015 21.139 -6.51648 1.45471 -0.425004 +5707 4 21.4543 35.0255 21.9119 2.52902 -3.67403 -7.94594 +5708 4 21.5071 34.7067 20.3201 -1.1119 -0.149268 16.7291 +5709 6 37.136 34.5081 26.161 6.62209 -8.97684 -22.2932 +5710 4 37.2438 34.333 25.2112 -5.73965 -6.14541 10.65 +5711 4 37.5173 35.375 26.2088 1.33918 12.2816 12.8311 +5712 6 49.3593 27.1123 23.4681 27.9614 -13.0657 2.71617 +5713 4 48.46 27.3383 23.3348 -38.0547 10.3981 -3.53627 +5714 4 49.5827 26.632 22.6632 1.14175 -6.15755 -6.01297 +5715 6 2.6463 41.7198 27.6524 7.3894 17.9878 -25.5957 +5716 4 2.49639 41.7504 26.6775 -8.79282 -10.4379 14.5056 +5717 4 3.38399 0.440368 27.7439 -10.0848 -7.80081 10.7778 +5718 6 28.2486 5.66281 0.851705 -28.2484 -11.3463 5.20358 +5719 4 29.1342 5.88017 0.643235 30.8656 11.4658 -5.99415 +5720 4 28.269 4.69693 0.891643 -4.88577 1.64465 1.4719 +5721 6 46.3319 19.9354 30.6504 10.2867 19.401 8.99033 +5722 4 46.9123 19.9353 29.8821 -3.84989 -4.07474 -6.11394 +5723 4 46.5975 20.7732 31.0971 -12.3274 -18.5124 -2.17733 +5724 6 3.63748 25.7835 21.5531 -13.3498 -8.40935 -29.3244 +5725 4 3.82697 24.8656 21.7578 10.5845 0.467441 11.0774 +5726 4 3.24958 25.6945 20.6565 5.98204 10.7305 11.6574 +5727 6 2.75525 19.0991 29.6309 -15.3907 3.66354 13.2976 +5728 4 3.52302 18.6052 29.9384 7.69741 -2.11378 -3.28897 +5729 4 2.98375 19.5594 28.8227 11.6258 3.58084 -5.99316 +5730 6 11.8998 35.7779 24.2574 -1.81403 7.91701 -5.71356 +5731 4 12.4147 34.9912 24.3376 10.7342 -20.9531 7.85436 +5732 4 12.5443 36.3811 23.8879 2.19538 16 -3.69366 +5733 6 52.3427 30.4062 14.294 22.5839 4.39347 1.37497 +5734 4 52.8745 31.0934 14.7488 -8.66891 -1.23278 -4.46489 +5735 4 51.4935 30.7804 14.0876 -13.5204 11.8147 1.32314 +5736 6 0.0822874 24.3672 32.1291 -8.34182 -9.5272 -6.40877 +5737 4 0.828194 24.8082 31.7001 -5.59692 5.0286 6.41936 +5738 4 -0.0482457 24.7479 33.0025 4.35174 8.79498 5.58774 +5739 6 31.4966 23.7292 38.8152 19.1094 38.0757 -4.99319 +5740 4 31.5999 23.5133 39.7508 -8.21927 -12.2318 -1.63758 +5741 4 30.9751 23.0699 38.3783 -13.0662 -23.7861 4.62116 +5742 6 52.1169 21.6052 3.50792 14.3711 -14.904 -13.5765 +5743 4 52.8807 21.6364 2.89306 -16.3122 -4.91238 6.22228 +5744 4 52.1257 22.4771 3.8768 -2.65107 18.1744 9.91254 +5745 6 31.7478 33.9414 11.5999 6.40399 -14.705 -7.35618 +5746 4 31.326 34.316 12.3745 -3.98661 3.76902 9.36008 +5747 4 32.1024 33.0666 11.8569 -5.74966 15.1553 -0.43871 +5748 6 7.04869 17.6722 16.6738 15.5169 9.78585 -46.6303 +5749 4 6.86408 17.1452 17.4554 -1.12856 -17.4359 1.80272 +5750 4 7.18951 17.0724 15.8577 -9.09698 16.5018 49.1326 +5751 6 51.856 41.8666 22.1892 3.84753 25.5265 -21.3427 +5752 4 52.3772 41.4924 22.8897 9.65371 -13.9556 16.5062 +5753 4 51.0512 41.3628 22.1522 -12.8828 -14.9996 6.2925 +5754 6 50.8708 9.92691 25.9357 -19.3562 -16.2947 3.52683 +5755 4 50.5833 10.1225 25.0455 -2.85771 2.39787 -5.58996 +5756 4 51.6551 10.4289 26.0882 17.2727 16.0662 4.10656 +5757 6 8.99927 39.8664 13.8488 -8.14038 -13.6283 -23.156 +5758 4 9.59929 39.3497 14.3885 6.06913 -3.61279 3.55219 +5759 4 8.79522 39.3067 13.0547 7.60199 16.2117 22.1745 +5760 6 40.7023 25.5302 0.148896 6.79038 -13.4508 8.01702 +5761 4 40.3789 25.4701 1.07476 14.4856 1.96217 -11.1718 +5762 4 41.6802 25.6099 0.149801 -17.1473 -2.90233 2.89792 +5763 6 46.6909 7.84537 22.8702 9.17253 9.27189 2.7581 +5764 4 46.223 7.4121 23.6122 6.69651 11.5962 -1.82232 +5765 4 47.0858 8.70418 23.1544 -10.5797 -14.2101 5.83025 +5766 6 21.013 12.9106 9.96683 -11.4772 33.9385 12.3935 +5767 4 21.4714 12.292 10.5062 17.1864 -22.5118 18.142 +5768 4 21.2487 12.7153 9.07972 8.38308 -10.8862 -30.7653 +5769 6 24.8549 0.515446 28.6008 5.68052 19.4063 -7.13145 +5770 4 24.6132 0.0822417 27.7678 -2.25298 -0.561161 -0.933523 +5771 4 24.9931 1.46483 28.3802 -3.69568 -16.6941 4.65055 +5772 6 9.93738 22.6806 8.27387 -17.0851 30.8612 6.83622 +5773 4 10.4469 21.9921 7.84938 5.97494 0.327216 -18.4105 +5774 4 9.65147 23.3826 7.61609 12.4321 -25.0338 8.46255 +5775 6 33.2759 9.25001 23.8237 4.47891 -44.2955 15.8461 +5776 4 33.2652 10.105 23.448 0.909732 36.8069 -18.0196 +5777 4 34.1325 8.84557 23.5962 -5.93924 6.51534 1.57833 +5778 6 47.795 20.3665 34.2866 5.36639 25.6433 -13.2606 +5779 4 47.2589 21.0165 33.753 7.81309 -27.8153 16.882 +5780 4 47.2984 19.5618 34.502 -10.2742 8.68957 -7.27829 +5781 6 7.49437 13.498 41.0843 -1.51987 -1.91843 -16.5508 +5782 4 7.4491 13.1887 40.147 4.71488 4.53153 18.247 +5783 4 8.31974 13.1617 41.4819 -4.68073 -1.19795 -7.02436 +5784 6 9.95832 23.5973 1.60681 5.21402 2.49741 5.68021 +5785 4 10.4402 24.1882 0.998507 -5.12041 -6.82862 1.89989 +5786 4 9.65493 22.8254 1.1174 1.14228 -2.219 -8.51506 +5787 6 27.3184 14.1623 11.3341 -13.0256 18.3326 19.191 +5788 4 27.0532 14.8043 10.6617 -0.288735 -3.87647 -1.15481 +5789 4 27.1082 14.6278 12.1878 10.7132 -11.7932 -20.1286 +5790 6 25.8363 31.783 17.8928 12.257 -31.4953 -8.75538 +5791 4 26.5912 31.2312 17.6268 -16.3657 -3.28218 2.7807 +5792 4 26.257 32.5845 18.0942 8.13437 40.9862 10.9181 +5793 6 28.5106 34.3419 0.227626 33.3873 17.7784 12.057 +5794 4 28.9852 33.8482 0.904042 3.3493 0.859906 2.37016 +5795 4 27.7339 33.8559 0.0766936 -35.6263 -19.3635 -8.63216 +5796 6 39.4752 27.6784 22.7097 42.3367 15.2059 -23.9811 +5797 4 38.5679 27.9307 22.8105 -22.3645 11.7157 0.32019 +5798 4 39.9498 28.4084 22.1978 -16.9125 -22.6846 16.1018 +5799 6 19.4034 35.5119 37.6428 33.5095 -11.1022 16.798 +5800 4 18.7953 34.9333 37.2031 -16.031 -7.23993 -11.3762 +5801 4 20.0399 34.8524 38.0282 -15.2165 20.9239 -9.15559 +5802 6 40.2577 30.223 10.7322 40.2352 -13.6393 -47.8395 +5803 4 40.0003 30.153 11.624 -20.3139 3.96126 40.955 +5804 4 39.7054 30.7997 10.2038 -14.6911 14.5022 3.62333 +5805 6 44.8252 28.467 36.0943 -27.9317 -39.6182 20.2271 +5806 4 44.1 27.9067 36.617 42.0807 42.9759 -26.5645 +5807 4 44.8315 29.4044 36.3472 -5.71594 -8.07431 0.279077 +5808 6 17.9328 13.9421 34.2756 -23.0398 37.6904 -16.8553 +5809 4 17.2847 14.658 34.0723 21.6532 -14.16 -3.36915 +5810 4 17.4769 13.4978 34.9742 -2.33669 -21.4636 20.9706 +5811 6 22.7722 11.8049 25.9053 18.1639 13.4769 -8.32772 +5812 4 22.5143 10.954 26.1764 -32.0329 -27.8082 11.3637 +5813 4 23.7113 11.6387 25.939 19.9678 17.8754 -6.33473 +5814 6 27.9844 31.9785 40.3628 4.4159 -7.73511 16.6787 +5815 4 28.3104 32.752 39.9101 2.36742 5.81951 -9.83175 +5816 4 27.6866 31.3262 39.7216 -3.89657 2.92736 -3.90823 +5817 6 29.7056 5.13899 29.6966 36.1554 -28.1732 -9.81385 +5818 4 29.3242 5.52633 30.4675 -11.5775 13.5815 21.5043 +5819 4 30.5867 4.74321 29.9895 -34.1051 15.4003 -14.984 +5820 6 3.10893 21.4798 2.76501 -7.99866 -19.5262 -7.43282 +5821 4 2.82658 22.3873 2.73831 -4.86294 14.1814 1.21532 +5822 4 2.47005 21.0041 2.20282 6.80672 4.92349 5.4824 +5823 6 13.6497 30.6638 39.7451 -45.1888 -1.5 -27.4221 +5824 4 14.5316 30.8766 39.996 26.4643 7.88404 -4.33129 +5825 4 13.4124 30.9677 38.8135 13.6057 -6.06521 34.9266 +5826 6 39.188 23.0895 28.2562 15.2318 22.185 -40.3341 +5827 4 39.2961 23.1894 27.2636 -4.5014 -1.37473 28.8386 +5828 4 38.6302 22.3345 28.3879 -14.2617 -17.3372 5.24228 +5829 6 16.9988 23.7489 0.769214 20.7079 -15.4466 5.05665 +5830 4 16.2107 23.4786 1.24898 -3.68938 2.33828 -2.20359 +5831 4 17.6949 23.1909 1.19915 -10.9726 17.7258 -9.6056 +5832 6 0.328251 33.6592 13.0294 5.05621 13.0457 -18.8804 +5833 4 55.0348 32.9975 13.677 0.78154 12.2617 9.8199 +5834 4 0.388277 34.5816 13.3997 -6.36603 -34.6234 2.68168 +5835 6 49.1005 40.6595 16.9496 -9.76098 4.73909 -13.8177 +5836 4 49.2151 40.9775 16.0207 -4.23419 -6.48803 14.4163 +5837 4 48.1506 40.7848 17.1408 8.79948 2.71791 -6.65809 +5838 6 52.1337 39.9918 15.1756 26.7545 10.0433 -2.50902 +5839 4 51.9708 40.0067 16.1202 -6.38877 -4.81519 5.40892 +5840 4 51.3465 39.7494 14.7166 -22.4824 -4.17003 -7.64187 +5841 6 29.052 37.1033 37.836 19.097 -0.968932 -4.5801 +5842 4 29.682 36.5364 38.3049 -8.87198 1.40853 -5.4338 +5843 4 28.3717 37.2982 38.474 -12.8547 4.6316 9.68073 +5844 6 4.87585 1.47991 27.5772 1.0193 4.57332 -1.4391 +5845 4 5.21258 1.06654 26.7686 1.92757 2.57678 7.5628 +5846 4 5.62617 1.67061 28.1638 -3.61661 -2.55781 -2.1886 +5847 6 43.5959 24.3463 30.211 -19.7182 -5.92862 14.3815 +5848 4 44.3514 23.9347 29.8066 13.2495 -10.0411 -7.84874 +5849 4 42.954 23.6392 30.3929 6.93549 5.0637 -4.64144 +5850 6 33.7524 3.52358 22.9355 4.65558 -3.45748 -24.1115 +5851 4 34.2253 2.7722 22.5212 -9.10678 14.6802 11.3369 +5852 4 33.6063 4.18077 22.2154 2.29559 -11.8514 17.7295 +5853 6 19.8909 13.4517 25.3922 5.25873 -5.74859 -7.9771 +5854 4 20.5096 14.0736 25.7535 5.66529 16.002 2.33546 +5855 4 19.9521 12.7313 26.0185 -3.34295 -15.2779 0.0169051 +5856 6 47.3737 23.1767 39.6212 -5.95621 11.0118 4.46955 +5857 4 47.7191 22.5265 39.0041 4.75348 -8.18234 -7.77672 +5858 4 47.7813 24.0201 39.3891 1.84918 -0.94156 0.213564 +5859 6 20.1771 18.6734 32.3906 -2.68035 -24.6067 18.319 +5860 4 19.7167 19.3347 31.8914 0.274713 15.8779 -14.5216 +5861 4 21.1289 18.7867 32.3383 1.39014 4.37005 -4.23212 +5862 6 0.462706 5.80795 25.6713 -7.84599 -7.21428 -45.242 +5863 4 0.323825 6.56383 25.0471 7.25451 -11.4554 20.6165 +5864 4 0.632949 6.14438 26.5418 1.37183 20.4375 17.7538 +5865 6 6.87393 19.55 31.9207 -32.7339 30.668 -22.5905 +5866 4 6.24577 19.9891 32.5577 15.6688 -11.8235 -17.9631 +5867 4 6.64633 19.9665 31.0139 13.7505 -20.7976 33.8805 +5868 6 6.72837 20.2799 38.5105 -3.64262 3.78431 -13.5507 +5869 4 5.92588 20.8248 38.5086 9.85336 -2.70512 -1.72466 +5870 4 6.83039 19.9897 39.4188 -3.49896 1.12624 1.5432 +5871 6 22.0356 25.927 12.2605 -11.8373 -4.76705 -8.63625 +5872 4 21.2326 25.5939 11.7351 40.6868 7.42656 16.975 +5873 4 22.8707 25.497 11.9923 -13.8486 -7.11072 -10.1952 +5874 6 39.3057 7.93299 2.64755 -0.118713 9.42534 0.0803503 +5875 4 39.6638 8.10481 3.53463 2.86319 -1.68774 -0.268253 +5876 4 39.5974 7.06378 2.35963 5.09861 -8.7519 2.38745 +5877 6 29.9647 22.0457 34.4057 2.14844 7.25734 -28.1517 +5878 4 30.9338 21.915 34.3365 -18.2911 3.03872 -0.832433 +5879 4 29.6238 22.2503 33.4865 4.56359 -4.84177 28.516 +5880 6 37.5951 16.2788 0.369586 8.64826 -19.3515 -0.400608 +5881 4 37.1939 15.3927 0.526929 9.97291 14.3398 -5.3998 +5882 4 38.4404 16.082 41.8172 -10.5319 -0.823814 4.55326 +5883 6 11.7218 13.8845 21.8896 14.7882 -39.2126 -46.5495 +5884 4 11.9305 13.3995 21.0267 -7.58848 27.5443 23.8472 +5885 4 11.7147 13.1405 22.4934 -2.11531 -1.20748 18.2217 +5886 6 33.352 10.9238 27.6262 4.19409 14.5082 -21.7958 +5887 4 32.741 11.5866 27.2704 3.79692 -6.80494 8.02232 +5888 4 34.0591 10.8732 26.9373 -11.2958 -2.76298 18.1193 +5889 6 30.9422 36.5217 10.1011 0.546516 -38.0529 -7.53065 +5890 4 31.037 36.4313 9.10316 -3.7795 -1.86296 33.6151 +5891 4 30.9555 35.5897 10.5034 1.2522 32.9448 -19.5962 +5892 6 45.5828 6.56917 25.2425 13.4794 -38.3135 -0.0969536 +5893 4 44.6735 6.51564 25.4913 -20.1668 12.9455 3.79285 +5894 4 45.8221 5.605 25.2656 2.31227 28.4662 -4.04899 +5895 6 9.53612 30.0233 12.041 13.8898 -20.9008 -19.4413 +5896 4 9.92894 30.5763 11.3437 -1.97905 0.820167 2.98642 +5897 4 9.13364 30.6129 12.6538 -15.721 17.9312 16.9413 +5898 6 53.0747 24.9738 1.38132 -1.86355 2.7084 19.7503 +5899 4 52.7154 24.2509 0.898374 -13.0694 -24.4059 -9.99565 +5900 4 53.2522 25.5795 0.686793 9.94881 23.634 -11.856 +5901 6 26.1984 24.7352 0.509304 -7.53082 -0.727442 -26.3589 +5902 4 25.609 24.783 41.6367 17.1237 -12.5609 6.929 +5903 4 25.7967 25.3842 1.06587 -1.32139 13.3231 25.2347 +5904 6 23.0109 2.41889 11.5345 -1.81733 -0.917938 -19.7561 +5905 4 22.156 2.16845 11.9124 1.98231 0.963836 1.10425 +5906 4 22.831 2.471 10.5696 1.38956 0.195961 11.1121 +5907 6 29.9165 12.8947 31.0013 41.0722 8.15666 -12.068 +5908 4 30.8272 12.8901 31.3843 -23.6061 -3.22469 3.62361 +5909 4 30.1671 13.0589 30.0659 -21.5099 -4.3955 11.2257 +5910 6 24.0423 16.1922 40.3682 -11.7161 -52.7791 -12.7633 +5911 4 23.7963 16.7427 41.0863 -4.03022 37.1909 22.8519 +5912 4 24.4513 16.6836 39.6566 3.29428 17.0417 2.56802 +5913 6 21.8759 29.9137 12.7377 16.7673 9.38207 5.68416 +5914 4 21.0615 29.603 12.3447 -12.732 2.54077 -5.12984 +5915 4 21.8572 30.8889 12.7388 -3.49843 -10.2696 0.0943897 +5916 6 45.2049 12.2865 6.6319 2.92472 30.2037 5.62675 +5917 4 45.4908 11.5347 6.14771 0.0808414 -27.1796 -10.0093 +5918 4 45.9331 12.9133 6.49804 -8.49251 3.31449 4.74769 +5919 6 7.58748 25.3948 38.035 37.4402 -5.69153 16.1754 +5920 4 8.20159 25.1941 37.2709 -20.479 6.14302 24.9331 +5921 4 8.13335 25.2556 38.8857 -20.6102 5.92378 -35.7711 +5922 6 46.1732 7.83303 16.6988 4.4841 14.5494 -17.535 +5923 4 46.5452 7.84101 15.8027 -9.24205 10.2202 -0.760543 +5924 4 46.6945 7.14485 17.0776 9.771 -19.5689 22.069 +5925 6 54.9675 12.85 7.71106 -14.5426 11.3809 9.40253 +5926 4 54.9732 13.8139 7.75484 8.59467 -0.566973 -8.90089 +5927 4 54.3786 12.658 8.45528 8.25441 -10.7611 -5.52346 +5928 6 26.93 39.6729 37.1759 35.4319 -17.0193 24.0328 +5929 4 27.7049 39.4447 36.6239 -16.3058 8.04164 -6.8945 +5930 4 27.2164 39.2553 38.0316 -23.1866 12.5553 -17.3208 +5931 6 27.0277 8.92497 38.0115 25.8258 -15.1538 -19.4143 +5932 4 26.3205 9.53863 38.1727 -14.2244 17.8778 -0.0983549 +5933 4 27.5327 9.26244 37.2322 -14.307 -2.33761 14.5508 +5934 6 8.04621 7.65921 29.9125 5.96085 -8.8046 12.0925 +5935 4 8.66182 7.92407 30.6202 -6.26406 -0.422529 -8.96361 +5936 4 7.80891 8.46925 29.4702 -0.676119 14.2 -7.80782 +5937 6 27.8751 27.8625 12.1001 -31.3933 22.4686 19.454 +5938 4 27.5095 28.719 12.4446 7.36494 -19.3603 -4.77408 +5939 4 28.6439 28.079 11.5991 25.5597 3.40516 -15.3306 +5940 6 23.5464 30.4867 38.1533 -1.61625 -6.62341 9.61758 +5941 4 24.0833 30.8354 38.8715 -5.37174 -4.61911 9.80189 +5942 4 23.9933 30.8636 37.4157 3.53805 3.96797 -22.0348 +5943 6 48.0805 24.2983 17.323 -13.282 16.609 -1.2587 +5944 4 47.4189 24.8263 17.8481 20.4082 -10.1323 -14.146 +5945 4 48.1392 24.7467 16.448 -1.93384 -6.90404 13.1726 +5946 6 38.5137 5.30503 40.3397 -7.95418 19.3032 15.6478 +5947 4 38.8605 4.51762 39.8919 14.9068 5.60332 0.485922 +5948 4 39.0782 6.12858 40.3573 -2.94219 -25.5867 -8.28862 +5949 6 31.2334 3.92786 33.7298 9.31662 9.08835 -13.8199 +5950 4 31.8178 4.24357 33.0198 -6.00608 1.6224 5.38661 +5951 4 31.5957 3.05883 33.9262 -1.57661 -10.2527 7.73336 +5952 6 41.2417 8.81323 38.1247 -0.484904 -12.0607 11.4744 +5953 4 40.9476 8.42023 38.9721 -0.376638 9.54125 -7.13918 +5954 4 41.2604 9.77162 38.2616 1.58028 -2.03482 4.89657 +5955 6 53.3602 29.1001 24.587 -11.0956 7.72569 2.80506 +5956 4 52.5731 28.5594 24.8544 13.5868 20.3826 -7.54714 +5957 4 53.0545 29.9696 24.221 1.09296 -21.6534 7.27768 +5958 6 54.9204 15.5334 40.7094 -9.73888 -15.8123 9.62316 +5959 4 54.8689 16.4143 40.4003 18.499 35.235 -15.9181 +5960 4 53.9936 15.418 40.9228 -4.36807 -19.1537 6.40504 +5961 6 46.4046 17.0769 31.8825 -4.88415 8.61979 -0.317809 +5962 4 46.5643 17.9902 31.5503 -4.54791 -14.0743 0.407713 +5963 4 45.6863 16.6828 31.3336 12.87 12.2001 8.08584 +5964 6 36.9136 25.0502 23.0508 4.56287 5.14957 -21.3849 +5965 4 37.1181 25.0639 23.9643 8.53293 7.7605 31.6671 +5966 4 36.2092 24.4176 22.9617 -10.0712 -5.98832 -5.36051 +5967 6 11.3786 4.43396 15.9309 9.37238 17.2608 -3.05203 +5968 4 11.3458 3.5794 15.4688 2.43716 9.1998 0.97888 +5969 4 11.7026 5.12247 15.2999 -5.70859 -16.4138 5.77914 +5970 6 12.7896 7.06818 19.4525 -2.66824 36.6483 10.7184 +5971 4 12.9865 6.29411 18.9417 0.495259 -24.323 -4.17525 +5972 4 12.2519 6.828 20.2299 7.04203 -8.59773 -13.3487 +5973 6 12.0617 33.6499 17.5439 8.15138 -13.8576 -23.5514 +5974 4 11.882 34.0654 18.3682 -11.1792 16.7137 24.4072 +5975 4 12.5902 32.8825 17.8108 -1.08307 -0.300652 -3.52071 +5976 6 10.2421 4.75805 2.56564 19.3085 -11.8452 1.86691 +5977 4 9.45693 4.42703 2.99801 -10.4664 -1.42643 2.59081 +5978 4 10.9264 4.04527 2.68225 -6.18235 16.1727 -3.70264 +5979 6 4.57251 36.8735 12.1563 3.74049 -23.6741 -21.1206 +5980 4 4.47996 37.7154 12.5491 -11.9533 34.2042 20.255 +5981 4 5.43811 36.9355 11.7449 0.921031 -10.3689 -0.351167 +5982 6 30.7412 35.3317 25.8213 -33.1423 -23.543 6.44877 +5983 4 31.2776 35.279 26.6136 10.5944 3.70967 -1.00248 +5984 4 29.9668 34.7615 26.0677 13.1622 11.7399 -12.7178 +5985 6 20.1808 7.16217 1.863 30.1084 16.4868 -11.867 +5986 4 20.9002 6.54767 2.16414 -16.0511 17.5979 -8.58506 +5987 4 20.6676 7.94845 1.45686 -14.4541 -29.1822 13.3394 +5988 6 21.7608 6.89709 28.9964 -11.5861 -1.80466 -8.03013 +5989 4 22.036 7.16072 29.8728 6.26891 1.69864 13.9065 +5990 4 22.5393 6.5849 28.5353 8.83449 0.101288 -1.59126 +5991 6 6.87368 37.1369 6.9386 0.0966708 26.3677 27.0276 +5992 4 7.29364 38.0249 6.81033 -7.58004 -19.2864 -7.26696 +5993 4 6.61926 37.1727 7.88431 1.83825 -7.02501 -19.6681 +5994 6 37.1919 18.383 16.2937 29.0289 34.5069 -53.2335 +5995 4 36.6258 18.6038 17.011 -19.1901 14.6481 22.2869 +5996 4 37.3395 19.2625 15.7718 -11.4936 -34.1346 27.3139 +5997 6 52.3871 25.4845 31.3088 43.0013 26.9533 24.6388 +5998 4 52.3889 26.4071 31.692 -12.9868 -26.5619 -15.078 +5999 4 53.3562 25.2868 31.368 -25.5563 -9.18093 -7.26498 +6000 6 3.9438 39.8542 16.3866 5.1752 -27.5036 1.27902 +6001 4 3.12325 39.6837 16.8533 -2.95342 6.97088 0.658243 +6002 4 4.2268 38.9387 16.1321 1.7457 31.291 -0.663648 +6003 6 26.0576 14.6358 18.3044 5.96149 26.4073 -5.45028 +6004 4 27.0205 14.6227 18.4365 -6.17521 2.0803 0.6884 +6005 4 25.8163 15.5963 18.2277 1.60591 -22.5499 1.70317 +6006 6 22.193 39.6312 23.63 -9.05536 -28.9999 9.83005 +6007 4 22.6639 40.3889 23.3083 10.2118 22.7493 1.36107 +6008 4 21.7625 39.8434 24.4837 8.53947 8.47814 -10.8223 +6009 6 5.99591 12.8758 22.3742 5.3436 -0.661706 -0.190442 +6010 4 6.14325 13.1833 21.4713 -0.679137 1.38292 -0.893953 +6011 4 6.87425 12.6139 22.6767 3.78948 -2.07704 1.05968 +6012 6 48.9338 28.1628 34.7078 -35.8712 26.2385 4.15493 +6013 4 48.201 27.5556 34.4701 19.6025 -0.265843 1.21851 +6014 4 49.8217 27.8183 34.7001 12.2446 -20.4038 -3.75147 +6015 6 7.76997 22.4407 33.2353 -5.03116 -11.9457 7.57841 +6016 4 8.01899 22.0009 34.0594 5.33952 7.11928 -2.86974 +6017 4 7.10669 21.8538 32.8613 -1.17853 4.26119 -2.40878 +6018 6 41.0955 39.6222 11.7091 10.6381 -27.5326 3.52715 +6019 4 40.5189 40.2602 11.288 0.0449404 21.7474 -0.525631 +6020 4 41.8612 39.9918 12.1934 -14.1016 15.1893 -9.59654 +6021 6 26.8828 37.915 39.359 -2.28209 0.567193 11.8658 +6022 4 27.0774 38.1179 40.3058 -8.7685 -4.90824 -13.677 +6023 4 25.9807 37.5277 39.3071 12.6176 5.79057 5.20946 +6024 6 16.8333 41.5427 16.7885 -17.5694 -7.84814 -1.75502 +6025 4 17.5277 0.148354 16.3589 5.69783 -2.62712 11.3029 +6026 4 16.9979 41.3393 17.726 8.37907 5.88226 -10.2657 +6027 6 19.018 8.99657 17.6669 -0.857073 -13.2853 32.8939 +6028 4 18.786 9.90902 17.9004 1.19423 -0.949069 -3.8378 +6029 4 19.1413 8.47286 18.5173 -2.13518 15.132 -32.6231 +6030 6 31.1034 24.3848 20.0884 -4.53251 11.7336 -2.81937 +6031 4 30.5766 24.6463 20.8643 6.13742 -4.20791 -6.36966 +6032 4 31.7352 25.0989 19.9557 0.422515 0.146513 0.562515 +6033 6 24.595 6.30881 27.6069 -9.90555 -11.0232 -14.6341 +6034 4 24.6965 6.6392 26.7007 0.89989 8.76246 8.56835 +6035 4 24.5083 5.35606 27.4824 0.344086 -1.65377 9.53776 +6036 6 11.6335 5.32908 8.21523 29.3959 14.5761 -12.3078 +6037 4 10.744 5.12885 8.4339 -32.4949 -9.42488 11.9016 +6038 4 11.5648 6.10082 7.62627 0.276207 -9.77668 5.48929 +6039 6 16.478 34.2375 17.2464 48.0037 -1.61779 7.84119 +6040 4 15.7306 34.6529 16.8034 2.48832 11.605 -8.49411 +6041 4 17.405 34.6677 17.061 -56.7063 -17.2336 2.19282 +6042 6 40.7477 40.4696 8.51561 8.11488 -8.65224 -15.2287 +6043 4 40.0224 40.6832 9.09702 -8.50867 2.70994 6.70857 +6044 4 40.4514 39.6579 8.0617 2.3787 8.8385 5.97324 +6045 6 42.7444 5.87231 14.2984 24.2128 7.61876 -1.56509 +6046 4 42.0757 5.96647 14.9632 -14.4615 -1.80987 8.42029 +6047 4 42.482 5.17586 13.6922 -11.2697 -3.69634 -0.0191913 +6048 6 14.3614 21.0573 6.06698 -40.3301 2.02826 20.3099 +6049 4 14.5082 21.6099 6.85229 1.25225 -5.13952 -5.68983 +6050 4 15.1941 20.9025 5.67555 35.2665 -1.55979 -15.977 +6051 6 16.3015 37.7733 18.121 -25.7671 9.10936 -15.4408 +6052 4 15.381 38.1761 18.2458 41.2545 -15.1679 7.93486 +6053 4 16.7788 37.6858 18.9587 -11.1023 5.71932 1.62274 +6054 6 40.7984 27.7161 27.1129 -11.0179 0.499807 -0.336913 +6055 4 41.4742 27.2927 27.66 5.56711 1.79851 -1.75817 +6056 4 41.2133 28.334 26.4954 6.67104 -1.0644 4.19578 +6057 6 44.9561 25.991 14.0487 25.7727 -16.7938 -19.0088 +6058 4 45.3739 25.1637 13.7108 -16.5098 12.8855 15.8726 +6059 4 45.5476 26.6442 13.6478 -7.0093 2.51014 3.36733 +6060 6 2.61494 33.9473 21.2474 -9.6198 2.06317 -4.83635 +6061 4 2.13704 34.7904 21.3802 4.44423 -7.12162 -0.559399 +6062 4 2.10703 33.4352 20.5879 2.52794 8.8644 7.26413 +6063 6 5.77575 4.45209 12.8318 1.03208 18.7287 8.08797 +6064 4 5.35339 3.69685 13.2518 -3.06112 -10.1665 -2.69945 +6065 4 5.8052 5.15326 13.507 0.887863 -7.02627 -5.52828 +6066 6 16.8649 5.92112 7.40874 19.9951 -5.29142 4.66315 +6067 4 16.4994 5.07825 7.12483 -4.58221 -9.71617 -5.56506 +6068 4 16.109 6.48147 7.52662 -16.4719 8.95214 3.19539 +6069 6 17.8298 38.4233 36.8534 9.258 40.3096 -0.310058 +6070 4 17.7926 39.4131 36.8935 -6.04129 -19.7424 1.84578 +6071 4 18.5177 38.2893 36.201 1.93535 -10.8086 -1.92368 +6072 6 43.3019 20.5959 5.44166 -6.9278 5.85438 -3.52603 +6073 4 43.1055 21.501 5.07158 -2.97833 -26.833 8.04502 +6074 4 42.4661 20.0651 5.41852 11.3272 16.2867 -2.99003 +6075 6 21.5372 23.2991 30.4448 -14.935 11.2275 -26.3705 +6076 4 20.9947 23.0537 31.1809 -7.12546 -6.28648 20.8256 +6077 4 20.8648 23.582 29.7655 22.6032 -4.28693 10.3415 +6078 6 0.251317 28.0486 36.1651 -22.0243 21.0356 -19.5016 +6079 4 1.02049 27.7114 36.6113 18.9729 -1.47718 6.47801 +6080 4 0.506474 28.8456 35.6445 2.58205 -12.8812 9.00708 +6081 6 3.04678 17.0589 11.5707 1.23946 -7.00965 -18.5436 +6082 4 3.14519 17.2619 12.4977 -1.89892 8.1653 13.6088 +6083 4 2.54959 17.7766 11.1613 1.73961 1.36316 5.23635 +6084 6 24.1645 37.0333 23.9496 -13.0802 10.7124 17.6799 +6085 4 23.6099 37.8384 23.8849 6.1763 -9.33563 -1.28122 +6086 4 24.4663 37.0147 24.8893 -3.58635 -1.49958 -18.3056 +6087 6 3.94341 20.5209 27.4789 6.12038 36.4957 26.1587 +6088 4 3.64002 20.0757 26.7101 -13.0247 -10.3927 -30.3524 +6089 4 3.8213 21.4921 27.3096 0.6263 -21.942 -1.90407 +6090 6 54.8381 2.78983 29.6272 25.3782 12.002 29.7256 +6091 4 54.8259 2.49183 30.5832 -3.08894 8.50949 -25.0172 +6092 4 0.681738 3.33643 29.5869 -23.0163 -14.7319 0.890579 +6093 6 27.1738 8.43221 31.7209 4.37325 44.8318 10.1666 +6094 4 26.7765 8.21235 30.8513 3.34031 12.9925 0.247925 +6095 4 27.4394 9.43578 31.8184 -18.7706 -51.1708 -12.8964 +6096 6 30.9422 1.62815 30.3909 7.68258 9.19266 14.5116 +6097 4 30.6848 0.902997 29.8247 -17.6873 -14.6962 -9.63211 +6098 4 30.1385 1.96768 30.8202 -2.70664 -9.08975 -4.26502 +6099 6 26.4126 36.4396 36.8407 14.7094 2.78685 2.16538 +6100 4 26.1754 35.936 36.0621 -1.37556 -1.6634 -9.1832 +6101 4 27.3614 36.6667 36.7609 -11.9856 -2.56278 0.470716 +6102 6 51.3051 10.055 21.7064 16.9271 -12.7171 -0.47742 +6103 4 50.71 9.38094 22.0984 13.3581 11.7028 -6.50503 +6104 4 52.1297 9.58932 21.3894 -28.6693 12.5934 9.83408 +6105 6 52.4269 12.3712 23.2743 -6.4707 23.0639 13.1163 +6106 4 51.7645 13.1043 23.2119 13.6159 -11.3613 1.42096 +6107 4 52.024 11.6223 22.842 -6.69009 -13.0182 -9.76131 +6108 6 10.0084 38.37 20.6075 21.9453 -2.41338 -4.30271 +6109 4 9.45069 38.2813 21.3825 -6.19229 -0.201962 6.85596 +6110 4 10.9137 38.1225 20.8794 -8.5598 0.614521 -3.9406 +6111 6 22.7031 33.2664 0.640708 10.9794 6.62646 4.85135 +6112 4 23.6679 33.2996 0.582378 1.56947 7.5672 2.73741 +6113 4 22.5144 32.4288 0.230474 -14.5468 -15.5809 -6.04383 +6114 6 14.0917 40.8812 25.4864 9.18744 8.89463 -14.7226 +6115 4 14.196 40.6884 26.4283 -5.63746 -5.20078 0.271339 +6116 4 13.2439 40.5125 25.1796 5.27736 1.6069 9.18822 +6117 6 42.7681 15.0783 14.9763 7.15748 5.71054 -2.59845 +6118 4 43.0785 15.7158 14.2901 -5.10451 -16.9901 16.8665 +6119 4 41.8327 15.2592 15.1092 -5.54173 -0.124331 1.80857 +6120 6 30.2406 7.22111 8.53832 -0.545825 26.9265 -4.64375 +6121 4 30.1758 8.19473 8.52708 -1.1145 -9.52086 -16.9196 +6122 4 30.4024 7.07989 9.45321 5.06633 -17.0605 24.2519 +6123 6 3.37759 19.8423 41.3077 23.4194 0.89426 -0.123069 +6124 4 3.19865 19.3681 40.4829 0.842743 3.23829 1.04749 +6125 4 4.34953 20.0012 41.2688 -20.407 -4.57585 2.1738 +6126 6 8.87423 25.1354 17.2017 -10.0567 -4.23249 -18.7298 +6127 4 8.96932 24.947 16.2256 5.94886 2.92938 28.6011 +6128 4 9.65182 24.8278 17.6915 0.0257745 -5.63434 -9.64419 +6129 6 9.32494 14.9555 22.0283 -12.5325 4.5599 7.62514 +6130 4 9.01993 14.8718 22.9489 -0.27625 1.365 -7.1979 +6131 4 10.1958 14.5523 22.0148 2.38734 -2.44115 -2.54227 +6132 6 2.03086 4.7751 20.8592 -0.302533 -25.5342 -8.8148 +6133 4 2.76807 5.37577 20.9697 7.90436 11.3601 5.00545 +6134 4 1.2576 5.15949 21.2703 -7.54078 11.376 6.7073 +6135 6 18.2964 7.06718 3.86051 -0.633466 1.54328 39.8902 +6136 4 18.916 7.22135 3.16498 20.2468 5.35447 -22.1173 +6137 4 18.8081 6.54637 4.52758 -12.8964 10.087 -8.61721 +6138 6 17.0178 19.1734 19.8425 8.05121 8.342 4.19715 +6139 4 17.786 18.9037 19.3194 -9.06534 -4.96345 -2.22737 +6140 4 16.269 18.585 19.6427 11.1227 0.819232 -3.01639 +6141 6 4.30363 6.55267 21.3463 7.67654 -0.43578 -3.38259 +6142 4 4.33009 7.06923 20.5107 4.36212 -5.74714 10.2686 +6143 4 5.22777 6.26626 21.5669 -20.6993 9.2157 -12.5452 +6144 6 20.7848 36.9284 35.662 4.03453 1.95325 3.7669 +6145 4 20.2254 37.0836 34.8976 -2.25577 1.87165 -3.27163 +6146 4 20.2383 36.4327 36.2875 0.848364 -0.11832 4.44878 +6147 6 4.7306 15.0205 31.2333 -1.91968 -20.8619 8.65585 +6148 4 4.4229 14.7734 32.1398 6.18773 10.2906 -17.1472 +6149 4 4.73385 15.973 31.1263 -2.35963 8.87481 4.31723 +6150 6 2.35358 1.22877 17.5767 10.9459 -8.92502 -6.22121 +6151 4 3.05741 1.28614 16.8672 -19.772 5.07478 19.7417 +6152 4 1.94409 2.09607 17.7592 7.86728 -5.07336 -5.26938 +6153 6 34.6221 31.5613 19.8029 0.0167231 -1.91103 -0.857839 +6154 4 35.0026 31.8698 18.9629 1.12657 -3.13716 4.28436 +6155 4 34.4223 32.3623 20.3103 -0.485441 0.265221 -3.01806 +6156 6 24.1912 21.6103 13.5173 31.6251 8.72647 13.7111 +6157 4 25.0921 21.8731 13.8418 -25.6554 -7.43575 -12.369 +6158 4 23.5893 22.1875 13.984 -2.65104 7.77201 2.87587 +6159 6 37.2187 41.0834 5.69361 1.76676 -13.0415 -0.936073 +6160 4 37.8761 41.7354 5.91144 16.7665 3.57334 0.125879 +6161 4 36.4089 41.5349 5.88363 -19.4064 5.82624 -1.33385 +6162 6 8.4323 8.00063 20.2395 28.2224 -17.334 -6.20124 +6163 4 9.29892 8.115 20.6547 2.73811 -3.60152 -0.447724 +6164 4 7.94828 8.69862 20.6224 -29.3938 29.4062 12.6481 +6165 6 14.9357 18.8843 36.7618 11.8158 33.7978 0.271425 +6166 4 14.1259 19.2123 36.362 -3.40669 -6.42507 -0.135577 +6167 4 15.5651 19.6361 36.6422 -7.52364 -17.7077 5.06346 +6168 6 43.9725 40.6444 18.6569 4.16672 -2.33153 16.0012 +6169 4 43.9166 40.834 17.7203 0.682613 4.51617 -13.4207 +6170 4 44.9212 40.6761 18.9032 -12.0211 -3.47257 -3.21486 +6171 6 33.7852 32.2494 37.3449 -11.8504 2.76306 -14.1758 +6172 4 34.0177 32.2775 36.4055 -1.41242 -0.232407 11.1732 +6173 4 34.3686 31.6236 37.7745 10.7747 -2.06792 3.13276 +6174 6 5.09749 29.2901 24.0356 16.7213 -6.5526 19.7529 +6175 4 5.77222 29.487 24.7328 -11.5239 -2.29901 -14.2657 +6176 4 4.7684 30.1321 23.7215 -1.73734 11.0072 -2.10513 +6177 6 33.6153 36.4198 10.9805 1.47517 3.52666 5.33615 +6178 4 32.7579 36.4403 10.5596 -3.06779 3.10292 -7.60642 +6179 4 33.384 36.4828 11.91 5.71512 -0.747971 7.16991 +6180 6 28.3006 33.5952 13.1115 6.62888 -15.4249 13.7129 +6181 4 27.948 33.7778 12.2398 -4.56551 -8.24283 -4.77521 +6182 4 28.1705 32.6462 13.2914 -0.364449 12.3294 -7.26248 +6183 6 6.16378 19.058 24.2919 3.99573 -9.29146 -27.7059 +6184 4 6.01812 19.825 24.8144 -3.49512 27.1397 16.8881 +6185 4 6.29927 18.3335 24.8859 3.7649 -20.2974 16.0908 +6186 6 28.4267 19.9356 1.8581 6.30761 1.98196 1.30153 +6187 4 28.5945 19.3745 1.10227 -2.74725 -9.675 -9.29711 +6188 4 29.2893 20.1184 2.23075 1.76934 5.71608 2.57016 +6189 6 42.0557 23.969 9.55925 -0.174378 -1.97525 4.49576 +6190 4 42.3037 23.8044 10.4694 5.92504 9.79373 11.5418 +6191 4 41.7282 23.1152 9.29053 -8.19873 -12.6145 -11.7634 +6192 6 43.5187 7.30226 27.4319 7.08124 -12.3985 0.368771 +6193 4 42.7424 7.14751 27.9838 -5.23639 1.01312 3.8871 +6194 4 43.2552 7.97753 26.8025 -4.71413 8.37143 -8.21745 +6195 6 20.4824 33.0041 9.27291 -32.573 -27.3267 34.6611 +6196 4 19.7824 32.5876 9.93875 35.2414 32.5831 -36.6535 +6197 4 20.3431 33.9616 9.1663 -10.2228 -2.75758 9.24016 +6198 6 38.0326 35.2526 15.9362 -7.94884 -19.6622 -5.99631 +6199 4 37.3459 34.9971 15.2894 4.63074 2.95951 5.93375 +6200 4 37.9463 34.6017 16.6504 2.45283 5.99568 -2.76115 +6201 6 47.5301 20.8853 3.96175 -5.34824 -5.66637 20.3565 +6202 4 47.9759 21.3648 3.2498 -4.9297 7.97101 8.48596 +6203 4 47.5029 21.3928 4.81786 6.75175 -1.3172 -26.6206 +6204 6 10.9933 31.6966 41.4271 11.47 5.02521 -0.853614 +6205 4 11.6392 31.7665 40.7132 0.112137 -5.28149 3.10577 +6206 4 10.1353 31.6993 40.998 -8.62143 -0.203152 -1.66696 +6207 6 43.2403 12.6562 2.57215 9.62694 -8.68348 -18.5989 +6208 4 42.9077 12.993 3.39384 -2.38679 2.43178 19.528 +6209 4 44.033 12.1261 2.78242 -8.9232 8.2725 3.71991 +6210 6 49.4204 25.4105 21.1683 5.59269 -12.2048 -2.72561 +6211 4 50.0196 25.2987 20.4097 -7.64964 4.29225 2.01473 +6212 4 48.8877 24.5919 21.195 1.69169 7.44836 1.02425 +6213 6 1.95674 34.1403 26.4747 8.8762 -24.2704 6.47661 +6214 4 2.77674 33.6103 26.5537 -12.4269 14.6955 -4.62849 +6215 4 1.26657 33.4613 26.3994 -1.21739 9.31774 -1.03397 +6216 6 17.1306 20.8229 36.6851 -31.9931 14.1441 13.8122 +6217 4 16.9533 21.7471 36.9985 5.62896 -19.6931 -5.93312 +6218 4 18.0634 20.696 36.5868 23.783 -2.64609 -3.70934 +6219 6 36.6048 10.9866 3.71548 -5.44552 8.31799 24.2539 +6220 4 35.7423 11.3886 3.87785 -5.6936 5.55042 -13.8219 +6221 4 36.8135 10.7077 4.61447 10.9535 -7.59336 -0.361553 +6222 6 14.2169 20.6838 21.9439 11.6961 23.12 -6.3106 +6223 4 13.8085 20.2376 21.1912 1.98746 8.13024 -7.83415 +6224 4 14.8103 21.4259 21.6461 -14.674 -27.097 -1.82439 +6225 6 33.9151 12.2544 9.54899 39.8857 -26.0408 -21.0892 +6226 4 34.3088 11.5163 10.0208 11.0461 -3.70138 -11.6499 +6227 4 33.2997 12.4814 10.1903 -47.9458 31.9244 32.2008 +6228 6 21.8056 41.4836 2.15686 0.64336 -1.87746 -8.80618 +6229 4 22.0354 41.6672 1.22189 -5.57638 1.91412 12.8342 +6230 4 22.5122 40.9391 2.50884 5.16687 -0.375256 0.644554 +6231 6 20.9282 10.4547 14.1996 25.019 -0.0729632 25.5582 +6232 4 21.5922 10.842 14.8375 -21.0894 -6.80718 -21.5316 +6233 4 20.826 9.54084 14.5456 -0.887825 12.9084 -9.51249 +6234 6 6.24616 4.45231 24.6293 -10.9468 0.993291 2.39826 +6235 4 6.83688 4.17894 23.9311 12.242 -0.137787 -14.9911 +6236 4 5.68087 3.68408 24.7586 -3.59028 -1.51582 -1.5433 +6237 6 50.784 14.5954 23.4824 21.8736 9.84292 5.60122 +6238 4 51.2681 15.1205 24.1582 -9.03857 -7.6656 -10.4761 +6239 4 49.9341 14.3608 23.8519 -7.60536 -4.54693 6.65168 +6240 6 52.7678 13.9144 9.68214 -3.90955 36.1598 -0.40974 +6241 4 52.8738 13.0144 9.92216 4.47335 -34.5538 7.53363 +6242 4 51.8729 14.0092 9.35938 -14.036 0.105332 -6.17221 +6243 6 9.05048 2.05234 29.9152 -29.3842 -12.1538 -14.6176 +6244 4 9.42756 2.83336 30.2687 13.3628 24.1087 13.7335 +6245 4 8.09173 2.26823 29.8032 18.9866 -6.39081 0.174186 +6246 6 7.13499 29.9757 26.2377 7.52656 -33.046 2.78556 +6247 4 6.52748 30.39 26.8607 -0.20976 -1.88395 4.87081 +6248 4 7.49713 29.1538 26.6869 -11.4544 24.9502 -11.4644 +6249 6 49.1541 41.742 14.3355 11.4439 21.5488 -10.6063 +6250 4 49.5333 41.2573 13.5835 -2.72613 -5.13007 3.47372 +6251 4 49.526 0.750494 14.2401 -8.50163 -23.9907 2.80869 +6252 6 5.64545 3.82333 19.1929 -5.43924 -10.1162 19.2647 +6253 4 5.12472 3.39384 19.906 6.51959 7.46947 -11.8792 +6254 4 5.07872 3.8651 18.4273 -3.31865 2.78603 -7.74707 +6255 6 9.32747 35.8381 24.9081 -3.67476 7.0144 6.61099 +6256 4 10.2167 35.7622 24.5243 -1.5306 1.39279 3.84516 +6257 4 9.42305 36.4736 25.6393 1.10498 -0.920313 -3.33942 +6258 6 53.0258 29.7567 11.5493 -1.29773 -2.97991 8.71205 +6259 4 53.4398 30.4104 10.9769 2.6525 4.63524 -3.89524 +6260 4 52.8324 30.2122 12.386 1.27544 -1.91261 -4.55584 +6261 6 22.6082 9.97702 5.69106 1.45951 -2.04334 43.7981 +6262 4 23.4598 10.2484 6.09617 -7.85329 -3.83944 -13.5574 +6263 4 22.5497 10.2693 4.79236 2.60512 5.60546 -21.7219 +6264 6 39.5532 19.6216 2.68726 -3.50035 -14.5445 -22.3968 +6265 4 38.6563 19.3067 2.54039 -1.65167 0.121811 17.9309 +6266 4 39.9003 19.405 1.80953 18.3116 7.78412 6.67062 +6267 6 45.082 35.5833 7.81025 20.3465 -2.3491 -25.2688 +6268 4 45.1219 36.3229 8.40611 -5.73741 11.9797 15.8104 +6269 4 44.452 34.9332 8.12016 -12.4923 -3.86067 9.83054 +6270 6 29.7976 14.244 9.96067 -5.32248 -4.64296 1.12628 +6271 4 30.0443 14.0971 9.02808 -4.18819 -1.64606 2.67632 +6272 4 28.8444 14.0269 10.0606 18.5465 4.64021 -4.02524 +6273 6 29.2523 30.155 21.8932 -5.77992 6.30922 3.94049 +6274 4 29.1431 30.8143 21.21 -7.42967 10.4849 -3.0507 +6275 4 30.0153 29.6632 21.6201 11.6336 -14.2167 -2.13367 +6276 6 11.1107 18.8213 6.56056 -14.6836 -1.88929 0.635516 +6277 4 11.166 19.7501 6.27543 7.98891 -2.6539 -0.194038 +6278 4 11.9915 18.4225 6.59495 6.41359 9.14832 -2.51569 +6279 6 13.4142 39.1371 13.4638 17.7807 -10.3765 -23.6259 +6280 4 13.7831 39.7975 14.0449 5.16656 9.87024 9.85065 +6281 4 12.6066 38.8468 13.8734 -16.0883 -5.26763 6.93978 +6282 6 50.1521 12.9948 0.13749 23.7903 11.3983 42.7862 +6283 4 49.8531 12.6437 41.2486 -17.3674 -16.2897 -43.7514 +6284 4 50.6811 12.2823 0.528204 -2.61001 5.26075 1.59628 +6285 6 47.8279 31.3538 27.7873 0.535952 -14.579 -21.2406 +6286 4 47.8981 31.8966 28.5732 -11.876 9.28639 5.42067 +6287 4 46.9879 31.5201 27.3031 12.1261 3.81279 14.9113 +6288 6 27.708 1.63283 7.49454 14.1634 -3.44528 -21.3886 +6289 4 26.9442 1.71926 8.04828 -16.4795 3.87106 10.0363 +6290 4 27.4331 1.03137 6.77318 -2.44435 3.14912 6.58235 +6291 6 54.8843 20.7912 16.041 -0.591057 -23.5277 -19.4313 +6292 4 54.9506 20.9946 16.9763 2.49267 -3.51754 11.2958 +6293 4 0.215527 19.8591 15.8725 -6.64294 24.8159 10.1677 +6294 6 37.4309 32.9919 34.4461 -3.01999 17.5498 0.613574 +6295 4 37.2599 32.074 34.6492 -8.98721 -14.1314 1.69718 +6296 4 36.602 33.3843 34.0789 10.8556 -9.90957 7.57788 +6297 6 19.516 39.775 6.74949 1.2991 -23.719 -0.568837 +6298 4 19.1628 39.2461 5.9771 11.6696 10.1577 21.4746 +6299 4 19.8715 39.1258 7.41882 -10.6166 14.587 -19.1486 +6300 6 32.439 2.74298 8.0597 2.15016 14.1028 28.0311 +6301 4 32.8474 3.04427 8.91221 -2.20578 -4.83758 -21.9226 +6302 4 31.6043 2.37221 8.38063 -2.27075 -4.50389 -9.9889 +6303 6 12.9757 16.0783 4.05517 0.782156 -17.4841 -11.0101 +6304 4 12.5393 15.6612 4.81952 2.97976 0.136191 -5.67644 +6305 4 13.3707 15.3387 3.55371 -3.64889 7.0956 8.52646 +6306 6 4.65115 29.9533 5.41887 4.80886 14.2508 -32.4371 +6307 4 5.0407 30.2031 4.52094 -17.5959 -12.1853 28.663 +6308 4 3.95879 29.263 5.26663 23.43 17.9812 0.878069 +6309 6 29.754 32.1152 24.0535 7.2798 7.01713 3.37681 +6310 4 30.6602 32.1649 24.4187 -11.1956 -0.828668 -6.39664 +6311 4 29.7572 31.4388 23.3746 -2.03067 -7.97912 -3.55015 +6312 6 11.8649 30.6972 33.4692 4.66278 -43.8766 26.3819 +6313 4 11.8723 29.8544 34.0435 -6.78391 38.5593 -23.2698 +6314 4 12.7601 30.7129 33.1118 -0.162199 2.5806 0.32685 +6315 6 17.3589 40.4121 27.3072 22.6925 26.1242 -9.80885 +6316 4 17.3318 41.3765 27.4299 10.8839 -2.3351 -5.50809 +6317 4 16.5554 40.1462 27.6883 -41.5002 -17.3681 16.6281 +6318 6 8.67113 4.89706 8.92484 12.0335 -9.87957 -4.1983 +6319 4 8.33733 5.39218 8.1724 -5.0195 2.6367 -1.72337 +6320 4 8.22391 5.22927 9.70847 -2.49168 4.71619 2.25155 +6321 6 39.5722 17.6819 9.57834 18.7012 -23.4437 -36.958 +6322 4 39.2207 17.6668 10.4653 -7.32211 -9.11094 11.7967 +6323 4 39.6226 16.7555 9.16114 -8.90732 35.1542 21.3272 +6324 6 31.4906 30.1663 28.5669 -18.2413 -3.40307 10.1233 +6325 4 32.2933 30.4252 28.099 2.93126 -8.695 5.25695 +6326 4 31.6493 29.3506 29.0723 8.50077 6.58979 -7.17605 +6327 6 52.667 19.2904 40.0609 -3.10376 4.72625 -3.48654 +6328 4 52.9542 18.5867 39.4362 -2.88314 13.2503 8.01058 +6329 4 53.0181 20.1618 39.7754 -0.243354 -8.89628 -7.05583 +6330 6 3.24103 7.80987 9.85575 15.4795 13.9798 -0.387217 +6331 4 3.75934 8.59525 10.1836 -13.0283 -21.6848 -11.3123 +6332 4 3.84189 7.30622 9.27659 -5.58147 6.91981 6.81825 +6333 6 23.1336 35.2172 35.587 -21.8844 -14.3383 30.559 +6334 4 23.8289 35.3646 34.9695 18.2116 12.6911 -23.5817 +6335 4 22.438 35.8962 35.5045 5.76256 0.966742 -5.52301 +6336 6 19.4997 14.0668 20.8253 -20.4482 -5.33672 -12.8711 +6337 4 19.9465 14.5101 21.5526 -0.10572 6.16799 9.82761 +6338 4 18.517 14.0876 20.9737 19.1914 1.01522 3.6393 +6339 6 23.6166 15.8675 24.0247 18.6101 -11.8924 -11.0295 +6340 4 23.7056 16.8159 24.0204 -5.88143 19.7526 4.0278 +6341 4 24.4592 15.5679 23.6279 -14.5441 0.474754 5.50536 +6342 6 0.271665 30.4941 6.10208 19.3679 10.4089 38.3983 +6343 4 55.0639 30.1609 5.24948 -13.9023 -9.5098 -30.2095 +6344 4 54.47 30.83 6.54681 -8.02886 -2.57547 -7.81581 +6345 6 4.88814 13.205 29.1223 -11.8587 -43.2127 -22.2411 +6346 4 4.78002 13.8458 29.7909 -3.08187 32.2273 31.1649 +6347 4 5.63816 13.4614 28.593 12.4558 6.3486 -8.85318 +6348 6 54.2078 27.2696 19.1963 -15.9712 -23.151 25.2067 +6349 4 0.0774591 27.3551 19.591 11.6552 0.895327 2.86932 +6350 4 54.2345 27.7605 18.3958 2.66703 17.7524 -27.3595 +6351 6 13.918 35.7451 9.18145 -1.78919 -38.7722 -17.1362 +6352 4 13.6805 34.9997 8.54227 8.11159 28.2534 18.027 +6353 4 13.9675 36.5302 8.63631 -0.993585 8.08981 -9.4946 +6354 6 5.91273 31.9181 18.8024 -12.4461 1.37758 17.74 +6355 4 5.51416 32.8097 18.9023 4.86685 -6.68339 -12.1033 +6356 4 6.30341 31.7597 17.9414 -1.0189 10.0948 -10.5031 +6357 6 5.79665 28.8753 9.48388 1.22923 1.68801 -9.18455 +6358 4 5.13151 29.3325 10.0083 -4.81051 1.68465 1.48607 +6359 4 5.29369 28.2634 8.9143 2.26517 5.17431 2.85494 +6360 6 40.1173 6.05944 9.72118 13.8961 -11.6659 -14.1698 +6361 4 40.0092 6.65032 8.94634 5.33155 -13.6 11.5113 +6362 4 40.8322 5.39707 9.49335 -23.1878 23.6737 0.508505 +6363 6 20.33 13.449 41.3936 11.1096 -0.534149 -19.18 +6364 4 21.2311 13.7006 41.7531 -26.0398 -5.61362 -19.048 +6365 4 20.2547 13.6822 40.4168 8.50391 -3.95591 26.8537 +6366 6 14.4455 21.736 27.3642 10.1345 -2.11962 18.0607 +6367 4 15.3888 21.7922 27.5976 -10.3958 0.0660495 -7.924 +6368 4 14.3649 21.6255 26.4124 4.42937 0.724974 -0.20238 +6369 6 38.7561 1.79551 30.0553 7.9914 -17.3849 -15.575 +6370 4 38.4573 2.01955 30.9195 -8.42419 6.13431 27.6354 +6371 4 38.9299 2.64677 29.6557 3.10695 8.29419 -8.65227 +6372 6 5.60526 10.8558 14.1801 -12.7318 -17.5226 5.68918 +6373 4 4.9397 11.5438 14.0518 -0.153792 0.369728 -2.18729 +6374 4 5.10481 10.0791 14.5379 11.5553 16.0131 -9.09073 +6375 6 45.3957 36.7129 27.9145 12.4213 23.5208 -28.0365 +6376 4 46.0624 36.7782 28.6036 -4.12954 -6.22049 8.27184 +6377 4 45.8092 37.2197 27.1638 -19.7894 -19.9635 17.4029 +6378 6 54.0798 35.0308 20.3994 -2.843 -1.86615 -11.5734 +6379 4 53.8804 34.0877 20.4832 1.52986 -2.36109 -0.337181 +6380 4 53.937 35.2424 19.4598 0.882668 -0.831705 10.9264 +6381 6 42.0694 14.2202 28.4717 21.1483 -3.98018 21.7174 +6382 4 41.9885 13.9669 29.4143 -10.3093 2.59547 -11.4583 +6383 4 43.02 14.3987 28.405 -3.82604 1.35242 -7.96462 +6384 6 34.8498 7.69636 26.7062 10.2576 -3.81921 3.94078 +6385 4 35.6291 7.30563 27.124 0.895866 5.46509 7.50645 +6386 4 34.5698 7.0105 26.0965 -7.64543 -1.95318 -6.87837 +6387 6 49.6738 30.7035 23.8555 -19.3272 -4.41511 -13.3992 +6388 4 50.4901 31.166 23.8286 28.3544 13.2291 -0.764283 +6389 4 49.8241 29.9642 24.4268 4.30872 -17.0733 16.2757 +6390 6 50.9008 7.796 14.1645 9.55664 -5.64416 8.78132 +6391 4 50.8079 7.01141 13.6383 2.57079 -23.1487 -4.84087 +6392 4 50.5017 8.45024 13.6177 -13.1237 27.0593 -11.2067 +6393 6 4.26801 39.4668 27.8349 5.05862 -9.29033 0.915363 +6394 4 3.69733 40.2352 27.9464 -2.13812 3.43039 0.251988 +6395 4 3.85787 38.9439 27.1453 -8.48589 -4.99062 -8.23097 +6396 6 8.74801 32.8245 8.20645 -16.3778 -23.5545 -4.64115 +6397 4 8.1587 32.1369 7.77132 15.1044 25.0089 5.08958 +6398 4 8.83862 33.6223 7.65804 -4.44885 -3.27239 -3.39484 +6399 6 52.9644 25.4956 9.38778 -23.0628 41.5097 8.07386 +6400 4 51.9653 25.4466 9.50894 36.2156 4.27363 -7.84863 +6401 4 53.1697 26.4737 9.50477 -8.20239 -39.1491 -3.41364 +6402 6 29.5595 36.7246 19.4744 18.9803 -2.04176 16.4704 +6403 4 29.6949 37.303 18.726 -4.20274 3.37351 -9.90607 +6404 4 30.4598 36.6303 19.854 -15.3589 -5.02994 0.251134 +6405 6 52.32 36.0811 25.1124 8.57954 -21.5781 -32.5589 +6406 4 53.081 35.9362 25.6725 3.50304 3.9365 6.54391 +6407 4 51.6308 36.4579 25.6293 -16.5409 10.2166 18.3955 +6408 6 21.1806 15.7021 31.1799 -1.73968 4.64344 -14.8668 +6409 4 20.7524 16.2958 30.5301 6.89899 -9.15256 14.6363 +6410 4 20.4997 15.2544 31.7027 -1.32541 3.0922 -5.22806 +6411 6 10.6615 22.4234 39.4446 2.77058 -10.3375 -21.7461 +6412 4 10.8237 22.5242 38.4595 -6.54577 -4.89624 27.0726 +6413 4 10.2823 21.5329 39.6036 8.10661 10.4602 -7.72978 +6414 6 25.1119 11.6683 22.7275 17.9584 10.1803 -43.002 +6415 4 25.2932 11.5881 23.6503 -10.3644 -4.73542 30.1579 +6416 4 24.2275 11.4525 22.4127 -3.04384 -6.16919 15.0614 +6417 6 31.7847 10.4664 2.90738 14.6232 4.92747 -25.5509 +6418 4 32.6367 10.8084 3.16838 3.35352 3.27745 17.8769 +6419 4 31.9203 10.4929 1.94425 -15.217 -5.45404 8.94289 +6420 6 52.4827 36.4345 22.1596 -7.80713 -36.8893 3.58418 +6421 4 53.0619 36.0081 21.4904 -7.85296 7.00584 7.09748 +6422 4 52.1113 35.6558 22.6625 11.8438 27.843 -13.8236 +6423 6 46.2218 40.0356 27.0002 3.00948 19.3103 18.0239 +6424 4 46.4695 39.2891 26.4839 7.60887 -23.2108 -12.3358 +6425 4 45.8298 40.6551 26.3816 -4.98516 2.75312 2.41297 +6426 6 24.0859 36.731 39.1057 28.0861 3.14637 -13.7231 +6427 4 23.7868 35.8298 38.9338 -5.18553 -0.74556 5.28182 +6428 4 23.4629 37.185 39.6652 -17.6872 -1.49015 10.8999 +6429 6 22.3474 7.42423 31.8108 -22.1464 -34.764 6.81692 +6430 4 22.3426 8.34479 32.0749 -0.491553 12.3501 5.32307 +6431 4 21.6443 6.94951 32.3421 24.5486 22.6275 -17.4273 +6432 6 14.3601 18.3609 4.10227 -5.91068 -17.6869 34.0105 +6433 4 14.0198 17.4467 4.00899 4.58845 16.3972 -3.13031 +6434 4 14.1964 18.4938 5.07185 10.0688 2.42213 -23.7444 +6435 6 27.3176 38.4584 0.118061 26.6324 1.72941 22.4386 +6436 4 26.8721 39.2229 0.514978 -6.24738 0.955789 -1.68833 +6437 4 28.1825 38.4197 0.615747 -27.5588 -2.17115 -12.0629 +6438 6 18.6641 0.153005 12.2455 -30.1585 11.9093 7.70812 +6439 4 17.6838 0.288413 12.4195 29.795 -10.6896 -3.23208 +6440 4 18.9224 41.3021 12.7767 -6.14336 -8.14908 8.56265 +6441 6 49.4289 24.9791 25.34 -2.93287 6.40986 -7.21031 +6442 4 48.5336 24.6845 25.5066 -4.79022 -10.2209 3.00881 +6443 4 49.2657 25.7332 24.7569 10.0796 0.538989 -0.302405 +6444 6 52.0657 20.2866 15.752 -30.988 -5.77477 12.2451 +6445 4 52.9883 20.4648 15.7877 30.7647 6.19501 2.10932 +6446 4 51.7487 20.318 16.6754 2.59628 0.707672 -8.61894 +6447 6 49.6694 15.6466 38.5033 -2.36871 5.8496 0.21755 +6448 4 49.1634 15.9354 37.7317 2.81773 -6.75889 -8.88584 +6449 4 49.3364 16.2327 39.1899 -1.1635 1.82265 11.9188 +6450 6 15.9209 23.7098 13.4125 14.0576 3.0382 28.6395 +6451 4 16.4576 23.7581 14.2247 -6.14337 -14.5589 -15.9509 +6452 4 15.4928 24.5639 13.4473 -12.8057 7.70559 -12.0572 +6453 6 14.3535 29.1644 14.3158 -5.44214 8.41065 -10.6214 +6454 4 14.1107 29.5404 13.4323 4.3831 -8.60004 22.5031 +6455 4 14.1668 29.874 14.9595 1.02369 -3.68708 -8.8215 +6456 6 30.4209 19.8501 16.8941 13.513 -29.8099 -4.40702 +6457 4 30.8419 19.6061 17.7309 -1.16118 4.00396 0.0836579 +6458 4 29.8867 20.6126 17.0073 -13.0379 22.0094 6.56408 +6459 6 21.3171 21.0315 23.1347 13.77 4.04154 19.3244 +6460 4 22.2214 21.2364 23.4619 -15.8088 -1.32345 -6.31481 +6461 4 20.7299 21.1568 23.8987 5.07857 1.54253 -3.54042 +6462 6 32.3393 0.431439 25.2563 20.1104 -9.0179 2.05206 +6463 4 32.3376 0.357033 24.2893 -5.83171 4.85221 4.50445 +6464 4 31.4939 0.740536 25.5658 -20.5297 5.12544 -3.04931 +6465 6 26.1412 32.4208 27.5133 11.9844 8.82666 12.5058 +6466 4 25.6297 33.2181 27.3271 -3.7928 0.326337 -6.17907 +6467 4 25.9506 31.7475 26.8638 -6.12498 -3.36782 -14.5181 +6468 6 31.6886 23.0183 41.4596 0.904697 7.64904 11.3452 +6469 4 32.5758 22.6752 41.6838 -11.075 0.532718 -2.08438 +6470 4 31.0649 22.7115 0.227606 5.71652 1.16966 -4.3825 +6471 6 54.3662 17.838 10.7289 1.16641 13.6113 28.4031 +6472 4 53.5784 18.2682 10.4091 -15.835 11.3767 1.3744 +6473 4 54.5574 17.2244 10.05 12.0924 -25.2322 -22.7117 +6474 6 15.4007 28.5656 8.62044 -26.1749 5.76845 -41.3303 +6475 4 14.7273 28.9702 8.01425 13.7656 -2.21873 23.1298 +6476 4 15.8479 27.9621 8.001 5.22436 1.48231 12.0756 +6477 6 21.9302 22.318 27.6758 1.68517 -22.7815 -10.3197 +6478 4 22.2029 23.2377 27.6948 5.32233 7.77922 8.4028 +6479 4 21.9507 21.9579 28.5708 1.77406 4.33165 6.10734 +6480 6 2.9439 17.0434 8.14058 1.94164 -24.3442 -12.3304 +6481 4 3.71771 17.0381 7.53295 -10.9103 8.58946 10.7103 +6482 4 2.9095 17.8301 8.67828 12.1388 15.179 1.9509 +6483 6 27.5776 18.2769 3.9771 26.0492 -34.2565 5.18616 +6484 4 26.8914 18.9079 3.85686 -19.1066 25.6869 -8.0303 +6485 4 28.3968 18.6065 3.57961 -12.2542 3.89161 2.52414 +6486 6 24.7648 24.5394 8.45172 0.675902 5.99664 -6.73781 +6487 4 25.0691 23.6382 8.29185 0.995795 -2.08458 0.0885467 +6488 4 24.6379 24.6158 9.40394 1.7631 1.80546 -0.516948 +6489 6 41.9985 30.4652 13.7873 -12.418 22.2399 8.0521 +6490 4 42.948 30.5766 13.6065 -4.54142 -18.1038 -0.632901 +6491 4 41.6543 29.5567 13.7855 17.2179 -0.450275 -1.52495 +6492 6 15.7003 34.688 41.5836 22.5583 -4.71252 2.77114 +6493 4 16.4414 35.3131 41.7067 -7.89455 1.74939 1.29748 +6494 4 14.9091 35.1782 41.7999 -10.5684 8.94915 5.66738 +6495 6 11.14 19.7709 40.5827 8.16812 -24.8495 -13.7269 +6496 4 12.099 19.6958 40.4335 -6.97557 5.6239 6.72769 +6497 4 10.8269 18.8658 40.3418 -4.09458 16.1616 8.77151 +6498 6 47.4994 34.5266 14.3059 -7.29954 -13.2064 -47.3862 +6499 4 46.9486 35.2618 14.0194 -1.26876 14.2822 14.9014 +6500 4 47.5134 34.0178 13.447 14.161 -1.19014 30.6955 +6501 6 12.4113 26.9599 28.4986 7.53387 -39.615 -11.3807 +6502 4 13.2389 26.8759 29.0383 -9.69033 -7.26437 -10.917 +6503 4 12.3547 26.143 27.8911 8.77392 33.3418 27.7102 +6504 6 27.6324 16.2078 39.8226 -15.7166 38.3334 10.2244 +6505 4 27.1738 15.4871 40.2515 -0.529449 -16.0233 0.418904 +6506 4 28.2783 15.8881 39.2072 13.4358 -18.0852 -11.4488 +6507 6 33.41 31.2223 27.2648 1.06056 32.1352 -34.8736 +6508 4 34.1408 31.8147 27.4795 4.37007 -7.45055 8.12396 +6509 4 32.9956 31.7298 26.5244 2.74339 -19.701 12.9858 +6510 6 39.1079 39.5697 31.9277 -2.55925 2.09297 0.92959 +6511 4 38.7672 39.6549 31.0188 2.43701 -1.71218 7.87361 +6512 4 38.6143 40.212 32.4659 5.60044 -5.69156 -1.85126 +6513 6 22.8777 16.5449 19.9566 -5.65986 -8.80894 -1.36967 +6514 4 23.3352 15.8067 20.4264 -14.7096 4.17994 -10.0586 +6515 4 22.0919 16.2116 19.4632 15.4216 -6.99735 9.66589 +6516 6 23.9693 21.8661 10.5894 -36.2244 3.36606 3.40233 +6517 4 22.9782 21.9097 10.6297 20.8239 3.29656 -5.85881 +6518 4 24.1356 21.2379 11.286 10.3432 -8.66819 12.8402 +6519 6 40.1777 25.441 2.79106 -10.2872 18.2283 6.37262 +6520 4 40.1705 25.0132 3.63888 8.49445 -17.5146 10.0011 +6521 4 39.7592 26.2809 3.01477 -1.02299 2.45309 -8.63041 +6522 6 15.0237 19.7749 9.41859 -29.0071 17.4399 5.80075 +6523 4 14.7228 20.7104 9.1599 7.38 -34.1593 9.70733 +6524 4 14.2459 19.2857 9.84339 25.5779 21.3804 -17.4983 +6525 6 7.16152 24.8628 0.123297 -7.02966 -3.56682 11.7049 +6526 4 7.96668 24.8036 41.5398 15.214 -7.46464 -23.6733 +6527 4 7.46323 25.2953 0.914133 -6.27594 4.44234 13.0485 +6528 6 43.3927 10.9201 31.3407 25.4071 10.106 7.84859 +6529 4 43.8098 10.8609 30.45 -7.40798 -0.791197 19.4909 +6530 4 44.1598 10.9733 31.9767 -21.009 -0.343387 -21.8186 +6531 6 13.8353 19.068 27.8558 -6.19586 12.3763 0.85665 +6532 4 12.975 18.7858 28.1864 -1.64107 2.23065 2.52451 +6533 4 13.8413 20.053 27.8412 2.88957 -13.8419 -2.19198 +6534 6 3.4728 19.5924 9.6022 -44.5705 9.69836 1.75794 +6535 4 2.70361 20.0095 10.0844 20.5969 -13.9146 -9.89239 +6536 4 4.25765 19.8234 10.0844 13.5534 0.0599395 5.99295 +6537 6 51.0213 19.4268 7.70955 2.43945 12.0622 -23.2725 +6538 4 50.6325 20.2627 7.28999 21.6228 -31.5555 10.1722 +6539 4 51.8004 19.115 7.16203 -27.7652 18.9123 7.69536 +6540 6 42.2139 2.59999 10.4154 11.3377 -7.01405 -0.847173 +6541 4 43.144 2.57533 10.7556 -19.516 1.89174 -10.2127 +6542 4 42.1979 2.39197 9.45142 9.27815 6.14572 20.7298 +6543 6 30.7794 6.42968 35.1975 -13.4378 -7.3385 -2.08895 +6544 4 29.8146 6.43175 35.3648 9.73054 -4.02703 -1.93701 +6545 4 31.052 5.50707 35.0427 -6.67101 6.52405 0.860042 +6546 6 52.8733 36.9495 18.5906 -4.95733 10.1612 -6.16245 +6547 4 51.9909 36.5548 18.5738 -2.549 -5.51132 1.40056 +6548 4 52.7192 37.8514 18.247 7.64894 -10.0112 4.74408 +6549 6 44.2058 6.2999 1.04709 5.21291 8.10008 11.2107 +6550 4 44.5368 6.97198 1.69742 -2.24215 -10.2401 -12.34 +6551 4 44.9393 6.09517 0.464894 1.54959 1.89788 1.1267 +6552 6 42.1369 38.61 31.1886 17.67 -9.24899 26.4806 +6553 4 41.7623 38.8803 30.3687 -14.3725 6.55505 -24.001 +6554 4 41.498 38.8614 31.8609 -3.32676 4.75778 -0.202389 +6555 6 43.7164 12.7972 9.05712 5.81528 3.72875 -30.711 +6556 4 43.3247 13.6946 8.89573 9.87346 -21.9812 3.16194 +6557 4 44.14 12.4709 8.19462 -12.6006 16.8915 32.7492 +6558 6 13.3844 0.443398 6.51083 -17.4423 24 5.83044 +6559 4 13.1471 1.18968 7.12521 11.9969 -17.0568 -16.1514 +6560 4 13.404 0.824606 5.60344 -0.330864 -2.32474 10.3957 +6561 6 16.1322 13.2809 10.2756 -7.67495 0.483234 -7.74316 +6562 4 16.9315 12.7781 10.4995 -2.28882 -8.98658 -2.43525 +6563 4 15.4389 12.669 9.92885 16.2568 3.72445 6.60733 +6564 6 1.59909 8.47465 4.69565 -12.106 -24.0688 17.9122 +6565 4 1.97809 9.06493 4.05503 13.7499 12.9224 -12.6029 +6566 4 2.17818 8.51684 5.47441 1.43398 4.73372 -5.14276 +6567 6 37.2847 1.71984 10.5234 11.0189 -27.5723 -13.4042 +6568 4 37.2468 2.67416 10.4778 -4.00861 9.27523 10.0347 +6569 4 36.8996 1.35439 11.335 -2.27729 16.2243 3.90618 +6570 6 53.8329 9.87891 17.6846 -38.3798 -30.924 7.14602 +6571 4 54.5301 10.0186 17.0634 18.0368 1.02749 -18.7159 +6572 4 53.3473 9.06138 17.3773 12.8854 20.2391 7.24153 +6573 6 45.4804 30.6107 15.8042 -8.04753 0.598448 7.23065 +6574 4 44.8245 31.2304 16.205 12.7241 -16.0174 -7.51778 +6575 4 45.2045 29.6903 15.9459 -0.384376 11.4708 0.631615 +6576 6 39.9212 16.643 33.8508 -27.7636 -7.17353 -19.4615 +6577 4 39.1766 17.1755 33.458 21.1378 -12.4278 10.7513 +6578 4 39.8244 15.7487 33.4296 5.23768 21.8708 14.061 +6579 6 32.8655 24.7639 27.9361 20.284 59.6053 -7.49862 +6580 4 33.6165 25.1458 28.4374 -8.60268 -19.6727 -0.650124 +6581 4 32.6313 25.5876 27.4183 -1.69816 -34.155 10.7383 +6582 6 7.87466 31.6143 24.1101 1.9117 20.6925 26.3443 +6583 4 7.66972 30.8573 24.7192 5.27436 26.873 -8.7819 +6584 4 7.9908 32.4716 24.6533 -12.57 -44.6195 -20.0842 +6585 6 43.5378 41.3358 15.8218 9.28004 -2.58796 -1.50951 +6586 4 43.1443 0.2957 15.6997 -2.19094 2.48586 -2.7957 +6587 4 44.4004 41.3722 15.3768 -7.99823 -0.449815 2.36698 +6588 6 20.0371 29.5453 33.205 3.08504 -20.5033 -11.6211 +6589 4 20.9096 29.2965 33.5637 -2.90058 10.2459 9.35691 +6590 4 19.6251 30.2513 33.706 8.84517 7.80605 8.87396 +6591 6 43.4117 21.4438 18.6347 -11.1342 -15.0059 14.8538 +6592 4 43.0276 21.2687 19.5098 8.56326 4.46648 -0.801958 +6593 4 42.8532 20.9111 18.0542 1.01153 2.95656 -9.2223 +6594 6 3.44653 19.1197 18.4217 23.6769 1.99723 9.81042 +6595 4 3.20802 20.045 18.3207 -2.32682 2.96104 -2.33529 +6596 4 2.63398 18.6303 18.3598 -12.7596 -8.76931 -2.32568 +6597 6 41.6678 38.1102 16.3244 12.531 -42.2252 -39.0953 +6598 4 41.9368 37.3879 15.641 -15.3799 38.9729 30.6603 +6599 4 42.3331 38.0554 17.0146 -0.0757724 1.18921 2.99625 +6600 6 7.55561 36.3978 10.4983 -3.44092 15.1931 -1.45671 +6601 4 6.72339 36.2337 10.0108 12.3142 -8.52859 4.51616 +6602 4 7.946 35.5335 10.7116 -10.6452 2.04557 -4.50299 +6603 6 36.2515 19.1074 34.8142 -43.7142 -17.0801 -27.3746 +6604 4 35.3817 19.3303 34.3863 23.1726 -6.06315 12.306 +6605 4 36.4633 19.8781 35.3097 10.3 22.3537 14.1292 +6606 6 53.5678 24.9372 12.6442 30.4342 18.5181 -32.2976 +6607 4 53.8348 25.8921 12.6266 -11.9077 -21.6197 10.5864 +6608 4 54.0165 24.5977 11.8224 -16.4724 -4.37861 26.9125 +6609 6 31.6766 10.443 21.0806 4.21881 -9.06253 -2.47208 +6610 4 31.4001 9.76622 21.7243 -7.70504 9.2495 -8.08332 +6611 4 30.9288 10.6617 20.4921 1.78432 -8.02731 8.28605 +6612 6 18.1094 28.7798 17.1891 14.7524 22.0605 -19.6834 +6613 4 19.0758 28.769 16.9872 -20.2742 -2.10771 9.28657 +6614 4 17.7731 29.5847 16.7123 5.43167 -23.0331 15.3038 +6615 6 21.675 18.2354 36.8765 16.12 -15.5286 8.52342 +6616 4 22.5529 17.9072 36.565 -22.4082 10.693 4.11156 +6617 4 21.5572 17.762 37.7329 -6.04816 8.67317 -10.9669 +6618 6 25.0658 19.0188 34.2159 -51.8076 2.97265 19.7815 +6619 4 24.747 18.4039 34.9114 5.38902 10.2451 -10.362 +6620 4 25.8774 18.6629 33.96 52.7001 -22.9877 -15.275 +6621 6 15.5692 13.0234 5.56242 -6.58245 2.44228 -13.4315 +6622 4 15.9945 13.4237 6.33643 -0.981395 -11.5063 2.18089 +6623 4 15.4281 12.0558 5.58603 5.20341 13.6823 8.40676 +6624 6 54.4716 41.6235 14.8012 14.2089 2.8312 2.80672 +6625 4 54.7869 41.5367 15.7234 -10.706 -4.16636 -8.71187 +6626 4 53.6678 41.1066 14.6963 -6.31993 -3.99892 7.53898 +6627 6 1.6781 26.4654 31.3743 5.67012 -21.4195 51.4057 +6628 4 2.55869 26.331 31.7713 -6.41431 -1.4007 -7.54986 +6629 4 1.81482 26.7235 30.4972 11.6805 15.9936 -52.9786 +6630 6 32.3382 37.285 29.6856 -26.7217 17.5069 7.43983 +6631 4 31.5807 37.8924 29.918 20.5429 -15.6126 -5.39856 +6632 4 33.128 37.6701 30.0913 2.74033 -1.11204 0.131524 +6633 6 52.7155 21.0369 22.8986 -26.6856 13.1044 -7.83906 +6634 4 51.927 21.5218 22.5308 17.9584 -10.8856 16.9396 +6635 4 53.1096 20.6236 22.131 10.0871 -9.76004 -3.40095 +6636 6 32.7546 28.5936 40.5151 -16.005 5.57574 20.6704 +6637 4 31.9696 29.0914 40.2712 1.08408 5.35728 -15.103 +6638 4 32.4826 28.2925 41.3957 13.2257 -7.23298 -6.66392 +6639 6 23.6064 32.0719 16.3529 6.2601 0.887785 0.577407 +6640 4 24.375 31.9361 16.9584 -22.6405 4.1158 -3.2487 +6641 4 22.7879 32.3052 16.8361 12.3926 -5.56708 -0.502672 +6642 6 37.5201 9.16809 29.9792 -2.73778 -7.47015 7.66604 +6643 4 36.7801 8.78215 30.4957 3.311 11.363 -11.2805 +6644 4 37.2059 9.98527 29.541 -5.1069 -9.85197 8.55889 +6645 6 2.27705 24.391 14.5477 -18.8311 -23.8216 -15.5117 +6646 4 1.75426 24.0938 15.3142 10.0576 11.8704 2.19803 +6647 4 1.95568 23.7778 13.8474 11.5886 17.7779 11.9828 +6648 6 27.3753 28.7961 24.7726 7.21008 -25.2057 -20.8265 +6649 4 27.1644 28.4274 25.6317 -2.92196 -0.0765173 10.3399 +6650 4 27.4291 28.0161 24.1505 1.02404 24.316 14.9 +6651 6 16.7879 2.56531 14.3086 11.9129 14.2285 -1.69346 +6652 4 17.7185 2.38196 14.3175 13.0278 5.32386 8.84309 +6653 4 16.4775 1.81817 13.8231 -22.7045 -15.6449 -12.1127 +6654 6 21.8022 39.8027 36.8001 40.4582 11.674 1.33338 +6655 4 22.755 39.5599 36.9347 -17 12.4394 -0.288792 +6656 4 21.461 38.9709 36.5396 -21.7153 -28.8447 -11.0269 +6657 6 14.0716 6.47232 41.542 21.0202 -14.2424 -6.97231 +6658 4 14.9696 6.10406 41.5939 -1.81915 -4.72532 -7.76656 +6659 4 14.0403 6.99701 0.421866 -13.8031 9.98176 13.4178 +6660 6 14.5555 16.5106 9.31543 20.3876 4.44524 4.12907 +6661 4 15.4025 16.5964 9.78828 0.864554 -6.42184 -12.9633 +6662 4 13.9847 17.046 9.86181 -12.8914 3.93145 3.80898 +6663 6 8.66171 23.4817 30.5575 -0.244333 -0.896371 32.8135 +6664 4 9.54353 23.6001 30.2398 18.7576 4.73722 -27.2602 +6665 4 8.85707 23.3999 31.5064 -16.6456 -3.41855 -0.290363 +6666 6 37.6497 2.07069 20.0046 29.2824 -26.1096 14.9164 +6667 4 37.0584 2.2163 19.2662 -13.6051 13.4744 -1.64318 +6668 4 37.4656 2.68422 20.7276 -9.488 6.31449 -9.7769 +6669 6 42.7264 7.54802 8.0174 22.2735 -23.3375 63.966 +6670 4 43.1898 7.96838 7.30926 14.9789 10.8108 -11.9713 +6671 4 43.3711 7.43923 8.8454 -34.4126 10.1207 -51.4479 +6672 6 38.5672 29.6578 6.85692 25.3422 5.29964 1.58487 +6673 4 38.5311 29.2984 7.75245 -9.71234 0.328663 -2.10015 +6674 4 37.7248 29.5682 6.41889 -15.2832 -4.18317 0.54199 +6675 6 42.5348 15.7114 39.7967 1.15785 13.3588 -25.5786 +6676 4 42.7129 16.6429 39.5831 1.88136 -1.51067 11.9166 +6677 4 42.2359 15.3735 38.9271 3.70013 -4.77916 17.2749 +6678 6 19.8546 7.43685 22.0566 -22.5975 2.81071 25.7956 +6679 4 19.2803 8.13273 21.6746 8.521 -7.13733 1.21439 +6680 4 19.4015 7.21173 22.9242 12.7412 8.86068 -31.9054 +6681 6 27.421 3.23371 12.5304 27.0524 21.0752 -24.489 +6682 4 28.3367 3.35644 12.1327 -27.9555 -7.8832 14.1518 +6683 4 27.3543 2.31638 12.8154 4.42645 -1.52034 -0.990676 +6684 6 34.4011 6.50186 34.3664 -16.3424 -2.90191 9.94761 +6685 4 33.6712 7.15225 34.4215 6.78416 -7.62851 1.00734 +6686 4 34.1394 5.7575 34.9538 2.66911 12.7001 -5.69623 +6687 6 9.88701 27.9536 39.7574 38.1218 -1.21446 9.36845 +6688 4 10.8313 27.9815 40.1009 -35.4969 -5.93471 -11.3457 +6689 4 9.7403 28.8357 39.397 -3.9481 4.17466 -3.11552 +6690 6 50.5681 22.1235 6.40489 -3.33101 1.51672 6.50125 +6691 4 51.5163 22.3536 6.46403 -14.0562 3.33212 10.0382 +6692 4 50.0608 22.5915 7.10741 15.6039 -2.37345 -9.267 +6693 6 47.1098 11.477 30.0359 32.4056 2.61276 18.961 +6694 4 47.3696 10.9259 30.8115 -10.3246 7.95021 -16.9085 +6695 4 46.3045 11.1726 29.6407 -20.48 -14.5539 -1.24473 +6696 6 25.9367 28.4654 9.80931 -8.38409 -27.2904 31.5361 +6697 4 26.8395 28.2564 10.1264 -14.1867 1.81997 -4.27567 +6698 4 25.3175 27.9176 10.3882 19.4096 21.4407 -17.1039 +6699 6 35.4417 36.6052 19.4431 3.65383 9.51374 12.5698 +6700 4 35.4442 36.5892 20.4356 4.35023 4.13201 -20.4161 +6701 4 36.0823 37.2978 19.1702 -7.18083 -5.57131 7.61291 +6702 6 39.0947 17.861 12.3005 -1.37104 18.7141 6.38745 +6703 4 39.0516 18.8013 12.5757 6.4741 -5.57949 -8.41576 +6704 4 38.3925 17.481 12.8252 -9.64523 -10.3587 5.73293 +6705 6 2.67895 27.1328 2.39169 -0.469231 -1.96621 -7.87892 +6706 4 2.01695 27.5866 1.84113 6.06579 -3.44887 4.00529 +6707 4 2.54603 27.3828 3.31988 1.36543 -1.57126 -4.01383 +6708 6 12.3125 32.2183 21.5204 7.73608 31.3279 -34.5621 +6709 4 12.8754 32.1648 22.302 -15.5368 -9.13091 6.69049 +6710 4 11.4514 31.7997 21.5885 -0.151568 -8.94455 23.3893 +6711 6 32.8824 32.3641 8.46179 -18.8611 4.30442 3.1153 +6712 4 33.4241 32.9657 8.96292 17.2175 7.79223 5.74753 +6713 4 32.0088 32.7748 8.50666 0.635289 -6.40729 -7.5616 +6714 6 12.649 6.44414 31.9754 -2.83404 4.50046 10.0363 +6715 4 13.204 6.32185 31.2101 8.19857 -2.9014 -11.0209 +6716 4 11.7563 6.235 31.704 -2.09981 -3.08597 -3.85403 +6717 6 41.3663 27.7408 14.044 -7.1512 -14.0341 -18.9391 +6718 4 41.8178 27.3798 13.2339 -12.2472 13.3456 19.5442 +6719 4 40.4043 27.5413 13.9741 19.5004 0.843126 1.31278 +6720 6 6.61204 16.505 25.4358 4.38086 10.1107 -4.22872 +6721 4 7.40634 15.95 25.3995 -3.52048 -0.326181 -5.74655 +6722 4 5.93615 16.0015 24.9584 5.4209 -2.01242 3.85811 +6723 6 21.7595 39.2992 13.3504 -47.5104 6.20728 42.9111 +6724 4 22.3466 39.2605 12.6295 26.4998 6.28224 -34.1528 +6725 4 21.7095 40.2078 13.7281 10.6984 -16.5323 -14.9329 +6726 6 34.8487 6.01484 6.95222 -29.6963 0.326386 -14.1862 +6727 4 33.862 5.88861 6.88689 25.1099 2.0969 11.0318 +6728 4 35.0754 6.24807 6.0365 6.49139 -1.48305 5.74594 +6729 6 33.0274 30.4243 33.1708 -20.2868 -13.6057 -33.0226 +6730 4 32.107 30.5622 32.8069 24.6222 -1.48625 15.7647 +6731 4 33.1252 31.0225 33.8918 -2.19017 18.1524 16.6028 +6732 6 15.459 32.4153 12.1907 25.026 -14.7999 12.6103 +6733 4 16.3707 32.0454 12.2858 -22.5133 7.43237 -2.39957 +6734 4 15.4871 32.8857 11.3664 4.63911 10.1509 -16.175 +6735 6 12.6896 26.6018 21.3639 -15.0944 -25.6853 -2.70918 +6736 4 11.948 26.0906 21.6799 0.937138 -29.673 -19.3981 +6737 4 12.542 27.2759 21.9777 19.0907 58.813 21.5342 +6738 6 47.0229 36.3064 29.9951 -7.32095 -4.41829 24.4392 +6739 4 47.4263 37.0889 30.4354 -10.9743 -13.05 -1.23566 +6740 4 46.4286 35.8162 30.6445 23.161 23.2616 -16.2608 +6741 6 0.29284 12.714 23.4069 -35.5625 7.7859 6.41586 +6742 4 0.591011 11.8915 23 -3.04289 0.952694 -0.179009 +6743 4 54.2726 12.6526 23.4069 36.7156 0.482893 -0.227565 +6744 6 54.1717 18.9252 21.5683 -50.0663 20.0699 0.290361 +6745 4 -0.00468748 18.6783 21.9698 30.2345 -16.5238 -1.58257 +6746 4 54.0846 18.73 20.626 15.626 -5.42297 0.74208 +6747 6 25.7258 24.2992 23.7444 19.803 -45.4072 -0.235584 +6748 4 25.1532 23.5493 23.4006 14.0979 28.9064 13.4272 +6749 4 26.557 23.8171 24.0636 -29.432 23.3848 -10.2309 +6750 6 11.8983 29.0288 26.8736 6.09277 -0.515715 3.71925 +6751 4 12.595 29.6797 27.0784 -3.35093 -5.68029 1.25498 +6752 4 11.9864 28.3255 27.5444 1.01315 10.8055 -7.75858 +6753 6 47.9911 35.8567 10.6981 8.08413 -4.02984 -21.6227 +6754 4 48.7745 35.7734 10.1229 -13.6418 -1.85084 -2.1863 +6755 4 48.3792 36.2903 11.4463 -1.30569 7.34959 21.4512 +6756 6 47.672 29.8438 36.9511 38.562 -32.0587 -16.7646 +6757 4 48.1514 29.311 36.2244 -26.8687 25.3781 26.6073 +6758 4 46.9232 30.3209 36.5927 -0.690739 -0.634879 -8.58348 +6759 6 7.33835 12.3416 10.615 -8.89583 -3.33234 -10.1121 +6760 4 7.22469 12.7824 9.73793 -1.24183 -8.23722 19.221 +6761 4 6.50851 12.5236 11.1156 17.4449 -0.896679 -14.5349 +6762 6 52.929 15.961 4.90278 -10.2898 -1.28264 -8.50781 +6763 4 53.0348 16.1145 3.95774 -1.18717 -0.815743 4.35872 +6764 4 53.806 16.0238 5.26597 15.814 -0.370642 9.21047 +6765 6 10.6777 16.9586 34.6035 -55.1347 -38.7426 5.67968 +6766 4 10.8984 16.7766 35.5088 23.7364 14.024 15.8473 +6767 4 9.8802 16.3472 34.5582 30.0556 27.9196 -18.3163 +6768 6 25.1377 31.056 36.0048 1.42921 -10.848 -28.6765 +6769 4 25.7744 31.7772 36.0714 -0.417948 1.95283 3.18329 +6770 4 25.3475 30.6244 35.1463 -8.66047 8.51414 18.9355 +6771 6 34.0941 21.8921 41.4705 -2.59948 8.49748 21.8065 +6772 4 33.8376 21.0023 41.2487 -0.891159 -17.6747 -3.00217 +6773 4 34.5263 22.2081 40.6953 10.3371 11.5397 -24.1167 +6774 6 15.7674 30.0637 1.25444 19.4532 4.17941 -23.0135 +6775 4 15.204 30.4318 1.91689 -16.4157 4.77211 21.8875 +6776 4 16.1981 30.8773 0.915598 -5.77798 -19.2538 1.08217 +6777 6 29.5177 27.8662 16.6069 -21.9867 -20.8772 26.8051 +6778 4 29.4575 26.8938 16.8925 2.72258 42.9501 -5.19299 +6779 4 28.8337 28.3532 17.1557 16.905 -14.8206 -13.8895 +6780 6 39.6418 9.77683 0.55649 6.97543 15.8838 23.3716 +6781 4 40.1108 10.6055 0.868863 -11.4024 -23.0197 -7.66085 +6782 4 39.4946 9.23542 1.36828 3.21978 8.9832 -14.2415 +6783 6 1.52158 31.8692 16.4183 -13.8984 7.04184 27.8471 +6784 4 2.05742 32.2974 15.7673 16.5414 8.9668 -16.2997 +6785 4 1.54493 30.9444 16.2035 3.31157 -20.7597 -8.56027 +6786 6 8.73651 39.8559 25.0424 -4.76165 -15.5453 0.0774869 +6787 4 8.05377 39.648 25.6948 0.177415 -5.7342 -2.33302 +6788 4 8.86744 40.7877 25.1714 9.39418 20.2019 -3.50565 +6789 6 42.3206 10.2864 9.76098 2.95973 19.1246 -1.63703 +6790 4 42.201 10.133 10.7061 4.21692 -0.996774 -0.328573 +6791 4 42.7677 11.1578 9.6855 -5.09192 -13.1904 -0.0451331 +6792 6 13.2407 7.61713 1.96996 -7.39862 -1.41628 8.88927 +6793 4 13.9913 7.91748 2.51852 -7.45732 -2.50241 0.703823 +6794 4 12.5579 7.21318 2.54911 15.3337 9.06064 -6.21655 +6795 6 18.7418 40.0591 14.2229 14.6643 6.60726 6.61579 +6796 4 19.3344 39.8885 14.9901 -13.3575 3.17545 -12.3588 +6797 4 17.9636 39.4956 14.2872 3.6042 -5.87931 7.54738 +6798 6 20.1073 14.0529 38.5598 27.8117 -61.2518 1.76132 +6799 4 20.1641 13.6472 37.6602 -4.05869 13.902 17.7453 +6800 4 19.784 14.907 38.4293 -21.3136 56.4597 -12.4562 +6801 6 22.6529 28.8869 34.0687 6.58134 -12.6264 20.4136 +6802 4 23.051 28.2341 33.486 -0.980474 2.102 -8.59088 +6803 4 22.967 28.5961 34.9503 -6.50134 7.38476 -6.63172 +6804 6 22.6736 4.71248 5.24178 -0.00794307 -2.96021 -16.86 +6805 4 22.1728 3.90748 5.48978 2.26378 16.1145 9.27739 +6806 4 22.7088 5.35566 5.95806 -4.05577 -5.29394 11.9552 +6807 6 23.6374 34.0001 38.3917 50.061 26.1352 -20.3518 +6808 4 22.8137 33.6238 38.6177 -41.7704 -11.5062 -0.965889 +6809 4 23.6153 34.3835 37.4812 -9.56218 -11.3792 16.4738 +6810 6 48.3816 21.3644 17.2759 -0.964958 21.4078 15.1884 +6811 4 48.1603 22.346 17.2347 5.31328 -30.3781 -7.15015 +6812 4 48.2799 20.9337 16.4123 -2.86285 15.3202 1.32987 +6813 6 11.5786 11.0066 8.63803 -22.8025 30.9503 41.2381 +6814 4 11.6342 10.2487 9.24135 6.24209 -4.12245 -6.65597 +6815 4 11.0653 11.6976 9.17674 20.0011 -23.9124 -25.5895 +6816 6 40.098 28.1667 33.502 25.4322 5.13826 0.328547 +6817 4 41.0532 28.3457 33.4282 -8.43417 -7.39989 8.78785 +6818 4 39.8078 28.5143 32.6608 -12.8477 1.2165 -2.93222 +6819 6 47.3852 25.6796 5.28879 12.5804 32.9376 -10.0311 +6820 4 46.4546 25.5561 5.13624 -16.8804 -10.2001 -0.268496 +6821 4 47.5232 26.6241 5.03253 2.87445 -14.5067 3.75712 +6822 6 21.6604 35.221 23.9985 9.0652 15.9564 -12.6156 +6823 4 21.5339 34.4977 24.6161 5.50034 -7.33202 6.93593 +6824 4 22.5891 35.5406 24.0132 -10.9025 -9.97729 6.37443 +6825 6 8.25067 41.5023 8.40693 4.57396 0.593767 -7.67714 +6826 4 8.14583 40.8128 7.73311 1.23406 2.32353 -0.157563 +6827 4 7.86929 41.1416 9.20784 -2.18245 3.41182 6.12515 +6828 6 16.4756 31.0916 22.2208 -15.8048 -5.76047 -3.57767 +6829 4 16.9823 30.8797 21.4186 0.224111 -1.11381 3.57708 +6830 4 17.0871 31.1495 22.9566 10.3822 -1.94934 1.40451 +6831 6 54.7052 0.441622 28.3216 30.4392 7.42547 7.16367 +6832 4 0.670225 0.280878 28.2941 -2.60978 -25.0778 -11.1355 +6833 4 54.7831 1.35385 28.5964 -22.0828 12.0381 3.63841 +6834 6 48.4365 15.3814 4.18175 16.1137 -59.8395 -8.29881 +6835 4 49.2486 15.0627 4.66696 -19.7577 20.5705 -9.22457 +6836 4 48.202 14.5739 3.61717 1.65501 39.0327 16.4105 +6837 6 34.3447 6.98096 40.4233 28.1894 -26.1309 -0.966046 +6838 4 33.5941 7.1072 39.8443 -1.28272 -2.58724 -7.46065 +6839 4 35.0352 6.39393 39.9745 -30.768 20.5054 8.50532 +6840 6 41.3452 3.36617 16.9999 -11.8967 -16.9054 2.63506 +6841 4 41.0249 2.72492 17.6694 2.1854 6.18106 -7.89089 +6842 4 41.9449 3.92974 17.49 7.08552 9.22633 4.28017 +6843 6 48.4488 20.6937 14.5344 36.1561 -40.2628 27.2518 +6844 4 47.9962 21.3635 14.0898 -25.7182 45.1623 -29.349 +6845 4 49.3977 20.8911 14.4834 -7.22111 0.680744 -3.09477 +6846 6 52.5006 28.1422 37.1181 -0.438891 10.9489 1.55023 +6847 4 53.461 28.2559 37.0441 -2.53591 -5.73983 -7.32344 +6848 4 52.1579 27.9957 36.2188 6.05301 2.29627 6.02383 +6849 6 53.8778 18.5596 18.7916 -16.4261 -54.6782 2.06415 +6850 4 54.6924 18.1462 18.492 5.89253 -2.608 -0.931268 +6851 4 54.0684 19.4623 18.7843 11.279 55.5152 0.463912 +6852 6 40.9954 39.1455 28.7887 -28.6383 -4.85259 53.4888 +6853 4 41.3933 39.2419 27.9663 30.849 7.00679 -57.5311 +6854 4 40.0484 39.2316 28.6375 -4.32997 -1.25138 -0.266272 +6855 6 38.2708 8.75593 24.2289 27.2886 -4.9888 -5.43324 +6856 4 39.2171 8.59021 23.9715 -26.3742 3.09491 7.04217 +6857 4 38.3303 9.34105 24.9905 -3.83131 2.71498 5.53525 +6858 6 2.99948 29.1469 9.63392 26.6909 -34.1608 2.5373 +6859 4 2.51216 28.7995 8.89273 -4.75194 -2.8028 -9.24178 +6860 4 2.58111 29.9575 9.82954 -15.8869 33.6035 13.3424 +6861 6 27.5773 29.2771 18.3181 4.27818 -11.5166 33.1226 +6862 4 26.7531 29.1546 17.8331 -9.3021 -0.872639 -4.78576 +6863 4 27.3558 28.9731 19.2647 9.0806 12.9475 -44.783 +6864 6 11.8527 21.1658 10.1208 3.44892 -32.1211 19.512 +6865 4 12.1978 22.0146 9.89711 8.39983 22.4635 -8.03232 +6866 4 12.4593 20.8304 10.8135 -12.0936 9.66798 -13.0295 +6867 6 16.8988 32.3014 0.299949 1.29982 1.68058 -0.586211 +6868 4 17.7043 32.7282 0.600499 13.9817 -1.747 3.00212 +6869 4 16.3216 33.0562 0.17902 -12.1561 7.80428 -5.7129 +6870 6 1.309 17.4831 22.5447 23.3848 -11.3219 -15.6007 +6871 4 1.13597 16.5744 22.1718 3.15619 19.2398 8.80125 +6872 4 2.27868 17.6899 22.4311 -25.7511 -7.40397 3.71946 +6873 6 41.5587 6.87311 29.3039 4.08196 29.5448 1.53382 +6874 4 41.6919 5.95311 29.5356 2.80206 -5.98386 3.69024 +6875 4 41.9106 7.40602 30.0483 -3.99043 -10.4039 -5.51054 +6876 6 10.5167 10.7886 13.8618 17.7458 -17.1897 13.2051 +6877 4 10.6632 11.2096 13.003 1.79898 0.261401 -4.84225 +6878 4 11.2159 10.1 14.0373 -16.1376 17.4326 -7.31573 +6879 6 39.8332 15.4952 40.8309 13.3581 4.75609 3.89566 +6880 4 39.9392 16.0809 40.0548 0.3292 -3.56753 7.15077 +6881 4 40.6564 15.5643 41.3732 -15.0531 5.58747 -11.8726 +6882 6 26.5094 19.6057 40.5003 9.17758 -2.41024 9.24949 +6883 4 27.4312 19.885 40.5187 -1.32295 2.31326 -8.74715 +6884 4 26.4504 19.08 41.3172 -10.7617 -0.025449 -2.36491 +6885 6 54.0331 8.19348 13.7645 20.1265 23.4755 -3.20859 +6886 4 54.5379 7.42769 14.0195 10.1236 -9.46733 3.3174 +6887 4 53.1635 7.89609 13.5919 -33.2862 -9.18344 -4.84573 +6888 6 15.685 25.3343 10.6639 3.77823 -5.01457 0.699023 +6889 4 15.2925 25.3549 9.7704 -6.94194 -0.507815 8.78718 +6890 4 14.9859 25.2981 11.3464 3.26271 -0.250944 -15.837 +6891 6 18.6044 3.42728 21.9359 54.0117 -4.17358 13.1129 +6892 4 19.6007 3.50499 22.1915 -55.8621 -1.2706 -18.0159 +6893 4 18.5414 3.70523 21.0018 -0.6471 0.781857 10.4283 +6894 6 50.8906 20.6382 18.514 19.322 19.8933 14.7131 +6895 4 50.0771 21.0514 18.1693 2.40506 3.30677 2.13188 +6896 4 51.4314 21.2881 19.0676 -26.3068 -18.4046 -20.3942 +6897 6 53.3692 20.9044 31.2861 -2.87581 -0.0590227 -4.61483 +6898 4 53.3163 20.8663 32.2507 -1.10677 -1.05899 -2.14121 +6899 4 52.4655 20.8115 30.924 8.48272 0.484508 7.85381 +6900 6 52.8175 27.637 28.9992 -34.1073 -16.3293 -5.23745 +6901 4 52.1753 27.4604 29.7292 18.9476 13.4611 -8.14668 +6902 4 53.5412 28.184 29.256 17.7352 16.912 19.7012 +6903 6 33.3098 15.691 11.3293 10.3241 5.44869 29.2776 +6904 4 33.5439 15.9761 12.2647 -8.49351 -12.0766 -30.078 +6905 4 32.4682 16.1118 11.1139 -1.38634 1.49203 3.14806 +6906 6 20.3823 26.792 27.4754 10.6616 14.7237 17.2289 +6907 4 19.6846 27.4135 27.2507 -4.69437 -0.849554 -6.03625 +6908 4 20.895 27.2908 28.1563 -10.3656 -18.3754 -15.2612 +6909 6 8.54404 2.05454 14.1651 1.1449 13.7122 2.29602 +6910 4 8.12946 1.19872 14.2191 -6.02545 -13.9865 0.607463 +6911 4 8.06484 2.58201 14.8308 4.74922 -3.38849 -5.44478 +6912 6 40.1105 7.56396 40.6794 -0.469697 6.72942 -1.63666 +6913 4 39.7195 8.28533 41.2425 20.0171 -18.0739 -7.27063 +6914 4 40.8018 7.03949 41.1472 -13.6242 13.5344 3.71207 +6915 6 6.897 6.83213 10.7811 7.71606 15.0782 -3.77655 +6916 4 7.19774 7.75246 10.6132 -6.74961 -17.2243 4.00207 +6917 4 7.00156 6.6927 11.7358 -2.06706 0.697676 -4.80225 +6918 6 31.2469 6.57665 20.133 15.2512 -44.8317 5.05575 +6919 4 30.6435 5.99888 20.634 -3.65198 3.16249 1.16613 +6920 4 30.7682 7.35458 19.9689 -22.0921 35.6742 -6.0398 +6921 6 54.5384 21.0446 27.3066 23.2273 -48.3206 40.5729 +6922 4 0.0992734 20.2122 27.4067 -21.2046 24.987 7.15799 +6923 4 54.6588 21.2398 26.4073 -2.82622 20.9035 -45.5707 +6924 6 4.74298 23.1434 16.2203 -30.2995 19.4891 -12.6787 +6925 4 4.36556 24.0555 16.215 7.46998 -18.526 0.357752 +6926 4 5.49124 23.2367 16.7883 23.1348 -5.45784 14.6166 +6927 6 25.5466 11.0338 14.8277 10.3359 0.700294 4.3384 +6928 4 26.1246 10.3443 15.2243 -8.70528 11.4294 -11.7317 +6929 4 25.9183 11.8873 15.0941 -0.865353 -5.34287 -3.41216 +6930 6 41.1962 41.784 29.9422 -30.017 -5.50367 -10.8152 +6931 4 40.9141 40.905 29.5845 10.5201 22.1914 8.67773 +6932 4 40.3904 0.453034 29.9085 19.4524 -11.6054 2.3136 +6933 6 52.2783 15.2862 41.6211 7.07203 -4.19206 -10.8941 +6934 4 51.9431 15.9476 0.307056 -1.67854 11.1856 8.97788 +6935 4 51.5699 14.6487 41.5543 -8.05659 -11.9472 -4.98288 +6936 6 37.758 21.7866 37.8526 10.4754 12.291 4.40187 +6937 4 37.8833 20.8525 37.7239 2.64231 -18.5298 -3.43162 +6938 4 38.1062 21.9123 38.7409 -0.189838 4.59809 2.45253 +6939 6 23.846 9.72877 27.5599 -20.0483 -53.0743 -18.3837 +6940 4 23.7508 8.9538 26.878 9.78252 41.145 35.6193 +6941 4 23.2758 9.50619 28.3397 9.82275 7.24107 -18.911 +6942 6 43.0179 28.0371 32.8168 -8.27592 12.0689 -0.875134 +6943 4 42.8326 27.1827 33.2413 14.9994 1.75302 -2.99965 +6944 4 43.9358 28.1723 32.5349 -8.32605 -13.2452 6.20231 +6945 6 34.1493 21.223 11.895 -6.4617 -26.4803 6.62596 +6946 4 33.7114 20.3967 12.2433 5.74917 23.5867 -12.2191 +6947 4 33.6625 21.5015 11.0997 -1.34318 -2.64619 5.02085 +6948 6 10.5048 31.8203 10.0934 3.12763 27.8567 -5.97475 +6949 4 10.8893 32.6663 10.3856 -2.25958 -16.5293 2.97323 +6950 4 10.042 32.0955 9.27903 1.62317 -10.8132 6.61598 +6951 6 35.8582 37.1311 22.1219 17.442 6.8165 -15.3109 +6952 4 36.7754 37.4644 22.0121 -13.2022 -8.29883 -6.66499 +6953 4 35.6795 37.2674 23.0383 -11.5038 0.0185045 25.2366 +6954 6 27.2889 4.59659 27.4585 -59.4895 -12.2555 32.2126 +6955 4 27.8503 4.63259 28.2407 7.94553 1.46958 -1.61102 +6956 4 26.3513 4.38137 27.8533 49.6255 8.2673 -26.6042 +6957 6 39.0071 22.2889 10.6559 -18.7539 6.55471 8.53947 +6958 4 39.6145 22.0219 9.97399 11.0637 -4.63202 -10.5583 +6959 4 38.132 22.2267 10.2407 1.98377 -6.13574 3.6668 +6960 6 30.7475 39.195 10.9378 13.4076 -25.4475 -2.13886 +6961 4 31.7135 39.1987 10.9202 1.84768 25.2682 1.10777 +6962 4 30.6542 38.2342 10.8274 -15.9936 9.0572 -1.5893 +6963 6 44.6038 26.9469 2.19596 -3.02312 -2.7981 0.496435 +6964 4 44.789 26.0668 2.58199 4.34993 15.1048 -14.5643 +6965 4 45.3477 27.2287 1.63769 1.54159 -5.20589 8.29494 +6966 6 23.7761 14.5574 26.4892 -1.60295 28.5342 -20.4107 +6967 4 23.6176 15.1119 25.659 4.49284 -25.3407 28.839 +6968 4 23.2395 13.7622 26.4238 -2.18231 -2.53609 -2.40557 +6969 6 38.3444 13.3746 39.6516 36.4054 -1.80378 3.51049 +6970 4 39.1202 13.8805 40.0461 -33.1028 -11.4882 -12.1373 +6971 4 37.5326 13.855 39.8351 -2.35218 5.60767 6.28087 +6972 6 17.8972 17.2344 29.4073 9.50877 -9.96512 10.1834 +6973 4 17.6974 16.8197 28.5593 -3.90288 0.722299 -3.3346 +6974 4 17.259 17.9348 29.5179 -13.7448 8.39178 0.729907 +6975 6 17.4263 29.84 9.91085 4.63967 13.4244 18.4952 +6976 4 16.5241 29.7155 9.63978 -6.68442 -7.79832 -10.641 +6977 4 18.0121 29.6473 9.18714 6.17675 -5.88453 -9.84082 +6978 6 35.6257 6.05657 19.614 -2.53427 -7.67526 1.74575 +6979 4 35.1442 5.56448 18.9178 7.07991 15.7277 0.668344 +6980 4 35.8526 6.94177 19.2847 -2.44106 -6.98166 -5.33042 +6981 6 18.6731 22.2952 17.5195 -8.35574 4.99894 -0.254983 +6982 4 17.7298 22.4259 17.6349 -7.1371 0.699885 10.6378 +6983 4 18.7532 22.3981 16.578 9.97204 2.32932 -16.3296 +6984 6 20.0126 3.82895 32.2846 -5.38506 7.6032 10.998 +6985 4 19.7316 4.05659 31.3951 3.95105 0.959407 -6.40709 +6986 4 20.9087 3.45699 32.2166 -3.62371 1.18893 -2.87546 +6987 6 5.48106 6.97474 8.11911 -13.3431 -28.5569 -4.23146 +6988 4 5.76723 7.87539 8.05126 9.5873 19.9723 5.64469 +6989 4 5.84003 6.56862 8.91875 4.365 4.20298 7.41399 +6990 6 44.2055 20.527 25.594 -36.5422 -32.7496 -22.1294 +6991 4 44.4952 21.1964 26.2048 27.2712 12.1663 0.509182 +6992 4 44.8136 20.1687 24.9192 13.264 16.717 13.5958 +6993 6 43.9676 36.9898 17.8707 9.43563 13.9581 11.3899 +6994 4 44.6425 37.4866 17.3506 -13.9886 -14.2814 1.04264 +6995 4 43.5166 36.316 17.3518 1.57776 -4.71986 -9.07493 +6996 6 34.624 10.1249 16.2553 -3.80507 -0.870494 -23.8528 +6997 4 34.4029 10.0232 15.2766 7.60873 7.05542 33.3523 +6998 4 34.6485 11.0843 16.4397 0.136369 -4.79707 -6.11079 +6999 6 23.6588 3.43472 1.31587 2.0947 2.20184 -10.1691 +7000 4 23.5283 2.45383 1.23665 3.68597 29.2686 -10.0862 +7001 4 23.7829 3.95594 0.465507 -5.48879 -27.0668 21.3429 +7002 6 33.408 38.9514 5.0951 12.9752 29.4037 8.61745 +7003 4 33.0296 38.079 4.95882 -18.4714 -2.71742 3.9597 +7004 4 32.7559 39.6696 5.33685 4.56028 -29.4715 -9.24259 +7005 6 22.5612 32.5054 35.7914 -7.59797 17.3543 -6.08959 +7006 4 23.434 32.1498 35.9581 8.59623 -0.183209 1.98348 +7007 4 22.6598 33.4814 35.6698 2.01652 -18.126 2.22848 +7008 6 32.4197 37.2669 13.8205 20.7322 22.1346 -9.91782 +7009 4 31.6112 36.8955 13.5272 -29.3682 -10.7083 -8.61391 +7010 4 32.7793 36.5983 14.3861 8.71878 -17.2052 10.8721 +7011 6 52.6061 12.7509 39.5955 -8.08982 -5.36768 -0.728302 +7012 4 53.2357 13.3696 39.2333 6.80499 9.05338 -6.44134 +7013 4 53.0752 12.2813 40.2869 4.34006 -2.9945 3.85342 +7014 6 28.8406 14.5639 1.22393 13.2702 13.2594 -7.07732 +7015 4 28.2547 13.832 1.29641 -8.98786 -23.9917 -3.18497 +7016 4 28.3081 15.2705 1.57856 0.691728 8.20301 3.76967 +7017 6 1.46371 32.4171 23.3808 -12.1734 -25.5645 13.9938 +7018 4 1.52421 31.5049 23.0145 7.51613 19.861 -1.66683 +7019 4 1.90409 33.05 22.8306 10.4998 5.06095 -20.3958 +7020 6 54.3326 23.3294 28.9734 2.61182 15.3833 -1.51239 +7021 4 54.2696 22.9227 29.8387 -0.130455 -4.55084 5.05008 +7022 4 54.4476 22.6226 28.3359 -0.0534198 -9.82677 -0.516761 +7023 6 14.3165 12.143 35.6759 -19.2415 -8.81627 -0.503167 +7024 4 14.3877 12.7977 36.3527 0.233596 18.6669 11.2481 +7025 4 15.2077 11.8775 35.5438 25.0768 -7.98239 -7.51161 +7026 6 18.9926 6.51479 41.2701 -28.9824 -29.6237 1.81046 +7027 4 18.266 5.84223 41.3522 13.7729 17.3268 -5.20094 +7028 4 19.3309 6.57432 0.258232 8.64619 7.1183 4.95474 +7029 6 5.3156 17.8978 20.3375 -21.1545 16.5991 3.60383 +7030 4 4.72623 18.3448 19.6879 4.29754 -5.05212 8.41069 +7031 4 4.82948 17.9368 21.1935 9.1049 1.98802 -15.8618 +7032 6 24.7216 34.9676 30.1666 -3.07326 -14.2394 -14.8574 +7033 4 24.8542 35.9126 30.1802 4.14387 12.0412 4.3338 +7034 4 24.7023 34.7085 29.2239 -0.0690866 8.67132 12.606 +7035 6 31.8759 4.61762 18.1838 16.2734 -6.94643 -1.61547 +7036 4 31.7767 5.32612 18.8146 -0.693712 9.66586 8.6442 +7037 4 30.9961 4.53608 17.8264 -12.7431 -2.99311 -6.3499 +7038 6 8.70679 17.4876 5.93376 -7.2594 15.0659 3.57914 +7039 4 7.94553 18.1226 5.84491 19.4684 -9.25267 2.2845 +7040 4 9.55198 17.9922 5.98984 -15.4384 -2.82622 -0.0668602 +7041 6 29.8338 10.9771 14.4736 2.85583 -20.8689 4.17621 +7042 4 29.3487 11.4359 13.7779 -2.35633 12.0716 2.99849 +7043 4 29.9333 11.5067 15.2792 -5.11986 9.15119 -1.36774 +7044 6 48.7176 10.2992 32.5766 37.752 -4.2965 -7.5649 +7045 4 48.6861 9.98692 33.5109 4.36425 8.41374 -15.5521 +7046 4 49.6689 10.1741 32.2115 -43.6207 3.75412 17.6406 +7047 6 8.33261 15.6868 37.8739 25.2856 -16.7599 -34.932 +7048 4 8.10095 16.0156 38.719 -17.2941 17.7495 29.2541 +7049 4 7.84865 16.1686 37.1872 -4.77393 6.83012 10.4818 +7050 6 50.4 3.07893 17.326 6.75193 2.54677 -10.5223 +7051 4 49.8476 3.08454 16.5614 0.0537611 0.514048 -24.7797 +7052 4 49.7563 3.22783 17.9993 -5.52918 6.4504 35.6689 +7053 6 14.6925 38.3995 10.8943 -10.4545 -11.2686 -1.07851 +7054 4 14.3539 38.6226 11.7634 0.533319 14.8424 10.3104 +7055 4 14.2274 37.5681 10.7419 5.82896 -0.087222 -8.72758 +7056 6 34.1157 6.37736 10.827 20.4112 17.5403 9.63945 +7057 4 34.1356 7.15575 10.2337 -4.79421 -13.4894 2.09643 +7058 4 34.9392 6.47467 11.3721 -17.4677 -2.57189 -8.67394 +7059 6 7.16428 37.5549 17.6272 35.8206 -6.94283 1.42456 +7060 4 8.17672 37.4379 17.5039 -45.4701 3.04153 9.54579 +7061 4 6.9329 37.0909 18.4673 4.48983 7.2965 -12.9876 +7062 6 51.5173 11.3068 16.7982 -29.6345 12.4732 -19.9425 +7063 4 52.2329 10.8476 17.1999 24.0623 -16.8016 7.00331 +7064 4 51.4947 11.1437 15.8343 5.46468 -1.37513 9.57578 +7065 6 15.6604 8.64432 3.1895 3.55656 -13.2601 -18.336 +7066 4 15.3831 9.26805 3.84437 -11.3932 20.6181 15.5674 +7067 4 16.2117 8.03967 3.68493 6.317 -8.49687 -0.892024 +7068 6 5.4241 21.4549 11.925 7.11554 10.6798 -7.02681 +7069 4 5.33432 22.3429 11.4717 -4.65036 -17.889 17.4658 +7070 4 4.77116 21.2815 12.6313 -0.367847 15.68 -7.67111 +7071 6 50.1893 24.0442 37.9781 -13.1484 0.855785 -17.0816 +7072 4 49.5179 24.1845 37.2801 8.13829 0.111989 16.6227 +7073 4 50.739 23.3224 37.6715 2.2014 -1.01472 3.1635 +7074 6 39.7382 11.2507 31.6977 23.6406 7.23187 -3.58891 +7075 4 40.4046 11.8538 31.2923 -18.8268 -10.2166 5.80002 +7076 4 38.8713 11.6238 31.5229 -1.54541 8.70996 -4.13134 +7077 6 26.6923 10.8294 20.5841 1.50171 17.3672 -0.163562 +7078 4 26.3063 11.3901 21.299 5.00814 -17.7696 -11.6362 +7079 4 26.5519 9.91114 20.8376 -1.99146 -0.979444 5.82041 +7080 6 12.5744 17.5779 18.1705 9.62673 -31.396 -11.9521 +7081 4 12.2909 16.663 17.987 19.11 1.74385 -8.92353 +7082 4 11.8345 17.8227 18.6757 -30.0259 29.7826 25.4081 +7083 6 47.7778 31.6094 17.3292 -7.10666 -17.038 -8.06235 +7084 4 48.347 31.2547 18.014 2.28217 1.30733 4.94459 +7085 4 47.3418 30.8212 16.9416 1.10301 17.3121 -1.07651 +7086 6 1.06524 3.39018 18.5298 -14.3894 10.3619 10.5476 +7087 4 1.40487 3.81402 19.3241 14.4239 4.64695 -0.395869 +7088 4 0.13491 3.28998 18.7837 -2.56119 -4.67364 -10.5163 +7089 6 26.5953 20.387 15.3121 4.86749 -24.5982 -5.101 +7090 4 27.0693 19.5476 15.0746 -6.18915 17.8108 6.48343 +7091 4 25.6882 20.059 15.4501 7.15985 4.40883 -1.86988 +7092 6 42.0068 3.03472 36.7639 -8.02624 -14.3838 3.82934 +7093 4 41.5138 2.21919 36.6422 -1.8797 -9.24856 -19.1073 +7094 4 41.9017 3.12445 37.6992 6.42334 14.3979 20.8626 +7095 6 39.3283 22.4329 33.1866 16.7976 22.9312 16.1168 +7096 4 39.617 22.6043 34.1233 -9.1007 -15.4059 -24.4851 +7097 4 39.2996 23.351 32.8579 -1.9326 -13.3537 -7.72798 +7098 6 18.5014 34.9723 11.9503 -40.872 8.93582 -22.0032 +7099 4 19.313 34.895 12.3871 37.9781 -3.12322 33.9295 +7100 4 17.8134 35.1232 12.6133 -0.0311416 1.40314 8.7121 +7101 6 22.862 14.1089 0.203393 17.2545 -2.37957 19.5806 +7102 4 23.1276 14.8054 41.5255 0.219481 9.03583 -13.3452 +7103 4 23.4003 14.3117 0.999915 -8.23864 -6.67581 -7.59618 +7104 6 30.9898 16.6325 33.7811 -26.24 4.82889 -18.7278 +7105 4 30.4991 16.9295 32.9906 -1.06726 -7.21679 15.5744 +7106 4 31.8724 16.8786 33.545 20.2345 1.84197 6.64809 +7107 6 28.4142 35.5086 5.55132 5.25795 11.5001 -0.86936 +7108 4 29.133 34.8901 5.6729 7.87573 -11.0207 0.32142 +7109 4 28.8444 36.3678 5.44284 -5.96253 -1.38672 0.306744 +7110 6 2.06178 31.4487 10.6522 7.7724 2.5252 5.43788 +7111 4 2.46787 32.1741 10.1582 1.48866 -1.05725 0.00513454 +7112 4 1.12423 31.5492 10.4902 -10.7705 -1.69396 -4.48797 +7113 6 5.96168 9.75465 21.3469 -3.89643 8.81348 -50.5901 +7114 4 6.28958 10.5041 20.7544 -9.04712 -29.7196 22.9081 +7115 4 5.37557 9.21645 20.7377 15.5825 17.9805 22.1648 +7116 6 24.7784 26.6095 2.66066 11.1746 -2.24162 5.28408 +7117 4 23.9956 26.7754 2.10108 -2.29597 -10.0774 9.56872 +7118 4 24.6953 25.8682 3.30791 -10.2989 11.7132 -14.8816 +7119 6 45.7373 4.24983 18.6143 27.3178 -0.763462 -4.2154 +7120 4 46.5067 4.85242 18.4954 -19.0177 -2.03966 3.70694 +7121 4 46.1538 3.38182 18.4484 -14.6954 3.88493 3.6473 +7122 6 4.46307 0.776675 15.9004 -0.0751459 19.7124 -7.24544 +7123 4 4.28648 41.7452 15.8506 7.90268 -11.6504 4.49907 +7124 4 5.34722 0.941656 16.2766 -7.84 -9.44871 -1.18019 +7125 6 2.43543 19.4835 25.3975 -8.02289 7.34849 22.5637 +7126 4 1.8039 19.0427 26.0095 9.34608 -2.48106 -16.7091 +7127 4 2.63666 18.9452 24.6346 -2.8512 -10.1259 -3.82486 +7128 6 40.5893 8.48301 5.11314 -1.35782 -12.8068 -2.32465 +7129 4 40.7524 9.27543 5.61119 -3.30667 17.7402 10.4879 +7130 4 41.4486 8.05286 5.16027 3.34022 -8.8045 -8.92488 +7131 6 49.3107 22.3512 41.5276 -10.6582 56.3201 6.76971 +7132 4 48.577 22.7852 41.0387 15.264 -8.60422 5.01334 +7133 4 49.2575 21.458 41.2835 -0.448838 -46.7272 -11.6484 +7134 6 0.358901 40.9209 20.5803 -19.8443 -5.20423 -21.0143 +7135 4 0.209912 39.9476 20.5616 0.00996972 10.506 -0.843682 +7136 4 54.6254 41.351 20.0384 15.1519 -13.0167 14.2251 +7137 6 34.868 15.3449 38.0159 -4.77394 11.9701 -21.6163 +7138 4 34.21 16.0699 37.905 14.1938 -11.5268 -7.28032 +7139 4 35.478 15.4115 37.2329 -18.0572 6.07255 16.3223 +7140 6 7.76403 26.0071 29.8556 5.34791 -0.957035 4.21351 +7141 4 8.62364 26.4528 30.0224 -8.82329 -12.5157 -0.945539 +7142 4 7.90301 25.0604 30.0866 1.23738 19.4493 -2.25897 +7143 6 40.714 22.798 20.4449 30.2403 28.6605 -20.1452 +7144 4 41.3584 23.4838 20.081 -22.4198 -29.1089 11.875 +7145 4 40.2102 23.3285 21.0558 -12.075 4.18803 12.4472 +7146 6 37.6868 25.6422 36.0641 6.66209 -5.59755 13.6904 +7147 4 38.2808 24.8923 36.0269 4.65063 -3.44496 7.57849 +7148 4 37.3429 25.6351 35.1859 -16.0941 8.70932 -25.1352 +7149 6 5.45062 23.9828 10.2587 5.16865 5.9624 5.01697 +7150 4 5.97911 23.8188 9.45867 -6.21725 4.51436 8.29683 +7151 4 5.82702 24.8173 10.6422 -10.2102 -24.7042 -13.9856 +7152 6 48.3972 21.0585 38.1887 36.079 14.8531 -15.9941 +7153 4 48.9083 20.6932 38.9203 -9.15007 -3.24726 4.47194 +7154 4 49.1186 21.3212 37.5505 -33.8036 -6.43701 14.9947 +7155 6 15.2894 25.0118 3.53737 -15.5341 -16.8072 10.9824 +7156 4 15.3523 24.0463 3.54635 7.80908 -0.218079 -10.1213 +7157 4 14.6524 25.152 4.25109 -0.971191 12.1275 -1.41446 +7158 6 46.3973 40.2818 20.0864 -5.10979 -28.8528 0.810189 +7159 4 46.7099 39.3289 20.1836 -4.69047 35.7762 -3.66479 +7160 4 47.1343 40.8792 20.2285 11.4236 3.93541 -0.385178 +7161 6 34.6613 36.4755 0.335066 -24.7851 30.4749 -21.6933 +7162 4 34.8743 36.0541 1.15687 -4.43901 -4.57192 24.0914 +7163 4 33.7851 36.9546 0.454416 30.1492 -20.7825 2.99091 +7164 6 52.5881 7.99834 30.4195 9.51271 -12.4348 0.483116 +7165 4 52.1042 8.76616 30.7719 -8.49213 -7.21741 -10.9068 +7166 4 52.0722 7.46347 29.7764 0.520668 12.6171 10.1624 +7167 6 32.0714 3.86484 29.4697 -9.7538 -17.9077 -31.6249 +7168 4 31.6702 2.97314 29.6052 7.93851 20.6113 2.31556 +7169 4 32.0839 3.94733 28.4741 0.539668 -3.17995 32.4864 +7170 6 20.3786 17.8365 28.6466 -12.59 16.0252 -12.2548 +7171 4 19.5397 17.5939 29.0718 10.0495 1.57584 1.91854 +7172 4 20.0545 18.3008 27.843 10.529 -6.18443 10.1885 +7173 6 30.4085 41.1704 41.0135 6.18506 -3.22706 -14.2809 +7174 4 30.53 40.7341 40.1581 -10.3332 2.11637 -0.589059 +7175 4 31.2241 40.9477 41.4498 10.7912 2.88832 12.9661 +7176 6 35.4567 32.8541 27.9296 20.1033 20.3116 -25.2142 +7177 4 35.1103 33.2872 28.7174 -1.27312 4.66796 4.01126 +7178 4 35.9087 33.5476 27.342 -15.0191 -24.2746 21.4934 +7179 6 14.3794 6.67806 12.7301 -1.9413 28.2373 -4.00169 +7180 4 15.2373 6.26429 12.8613 2.01848 -2.11516 -0.858514 +7181 4 14.5332 7.65903 12.7289 -3.54891 -27.4927 -2.87641 +7182 6 41.884 41.5441 20.3292 17.5267 3.97767 -7.39307 +7183 4 42.6467 41.3531 19.7473 -6.80228 5.43899 6.41045 +7184 4 41.2989 40.8038 20.1922 -8.54368 -4.96293 -3.75352 +7185 6 46.4016 22.5784 8.86191 7.75251 -10.6521 7.11129 +7186 4 45.8476 21.8716 8.52158 -12.3576 2.35246 -8.51817 +7187 4 47.0146 22.0703 9.39636 1.75986 6.35736 5.22437 +7188 6 17.4049 20.6472 13.8946 9.03444 14.2526 1.49725 +7189 4 17.6929 21.5842 14.0543 -8.3446 -25.4959 -7.46489 +7190 4 17.3265 20.4984 12.9333 2.034 6.01629 5.63707 +7191 6 8.18883 9.49722 13.352 -36.2403 7.79383 -0.838203 +7192 4 7.38606 10.0563 13.5919 32.9103 -12.129 -3.09847 +7193 4 9.02271 9.90793 13.6245 -5.40631 9.4956 5.41337 +7194 6 7.5857 14.8045 29.5864 0.660595 8.18183 -2.22865 +7195 4 7.08502 14.4366 30.3218 -1.52277 2.83209 3.37304 +7196 4 7.02502 15.474 29.1565 2.15616 -5.78955 1.98978 +7197 6 29.5787 39.2199 22.642 -23.9064 2.77655 4.40715 +7198 4 29.7923 38.7231 23.4359 12.3113 -5.95711 5.92816 +7199 4 30.3289 39.2945 22.0576 16.6647 -3.01011 -3.30282 +7200 6 19.7261 28.8048 8.43629 7.07867 10.1416 -1.30332 +7201 4 19.5094 27.8711 8.56662 5.24428 2.50367 -2.7317 +7202 4 20.6808 28.8901 8.64157 -12.3267 -4.04756 -0.658665 +7203 6 20.0918 21.6433 25.9098 -22.8378 18.9737 -2.62589 +7204 4 20.6828 21.9331 26.6394 -14.5657 0.991195 -11.6344 +7205 4 19.2872 22.2354 25.9429 24.6623 -16.2361 5.64257 +7206 6 12.7798 16.1171 22.7918 2.83481 -1.66518 -8.4999 +7207 4 12.1052 16.761 22.5802 -5.26913 11.1277 0.000470885 +7208 4 12.4145 15.3113 22.3987 5.67676 1.62415 3.74644 +7209 6 7.09341 27.2127 17.9852 -17.6727 17.6357 -2.43489 +7210 4 7.71878 26.5086 17.8851 15.5779 -18.3258 -2.50971 +7211 4 7.24623 27.7931 17.2297 2.82114 0.873921 -0.89624 +7212 6 32.4121 8.69011 34.8574 -11.3856 31.068 25.9423 +7213 4 32.686 9.10208 35.716 -2.62469 -14.8204 -24.695 +7214 4 31.4981 9.04705 34.7249 20.8054 -13.4625 -4.53694 +7215 6 50.3489 28.2274 17.5408 2.96892 -19.9668 3.87059 +7216 4 50.2931 27.3328 17.9381 -3.71715 13.2344 -0.552608 +7217 4 51.012 28.0828 16.8476 -2.81747 8.99858 -3.49204 +7218 6 15.6752 32.1523 25.7996 -24.1097 -1.02752 -8.0065 +7219 4 16.4469 32.5721 26.1513 19.1192 7.47953 7.03048 +7220 4 15.1241 32.8942 25.4834 5.39501 -5.59697 3.80799 +7221 6 41.2942 22.0009 29.6469 23.8016 -11.3242 12.4312 +7222 4 40.6197 22.5451 29.2897 -20.6362 19.5621 -14.8771 +7223 4 40.8321 21.2604 30.0334 -1.27155 -6.80964 4.85239 +7224 6 24.5512 12.7478 8.87624 0.539479 -2.56763 -16.1827 +7225 4 24.2317 13.5544 9.29419 1.48927 0.294937 0.678301 +7226 4 24.2485 12.8104 7.9491 4.47413 -5.17195 11.4459 +7227 6 47.3043 20.1171 10.4067 20.0451 13.2477 8.4905 +7228 4 48.2327 20.3756 10.3708 -0.951507 4.56311 9.88278 +7229 4 47.2371 19.5522 9.64912 -14.6685 -17.4861 -17.2657 +7230 6 17.6686 14.2187 29.9453 7.31834 -6.07886 -8.28437 +7231 4 16.8567 14.6777 30.1627 -12.3548 11.6861 -0.426412 +7232 4 18.1621 14.7508 29.3045 -6.68566 0.573373 4.02912 +7233 6 21.3468 34.5864 28.5404 1.3464 21.7174 -7.002 +7234 4 21.5866 35.4807 28.2285 -6.04705 -7.23946 1.73439 +7235 4 21.8012 34.5133 29.372 6.90897 -8.71765 12.9147 +7236 6 35.0919 4.05058 4.01374 -15.5825 9.30565 11.5721 +7237 4 34.2387 3.74233 4.43927 22.4566 16.9059 -11.4445 +7238 4 35.1406 5.04582 3.93988 -11.3656 -25.7387 7.52347 +7239 6 29.9083 8.58745 22.5962 -15.8002 1.46007 -28.7439 +7240 4 29.4293 8.33193 21.7391 23.5037 3.33824 36.5279 +7241 4 30.4512 7.83881 22.8901 -6.5033 3.48596 -7.29863 +7242 6 9.80484 32.9578 15.933 -3.40746 -8.77641 -12.0557 +7243 4 9.78146 31.9986 16.1651 13.0086 23.7442 4.23133 +7244 4 10.4547 33.4728 16.4465 2.19651 -19.1398 5.78046 +7245 6 24.9207 14.2283 32.5839 15.8568 -2.03515 22.8032 +7246 4 25.4679 14.491 33.3602 -10.7028 -6.65113 -14.6818 +7247 4 24.5651 15.0495 32.2637 -5.99659 7.67207 -7.30645 +7248 6 49.6599 21.9679 26.2292 42.3899 27.0609 3.31449 +7249 4 50.4576 21.5325 26.6526 -24.3124 13.7703 -9.69582 +7250 4 49.9726 22.89 25.9802 -16.6307 -33.6109 8.97028 +7251 6 39.2146 29.6271 28.776 1.2649 -6.72815 -4.66326 +7252 4 39.3113 29.0399 29.5368 -1.10705 1.67847 4.24024 +7253 4 39.5646 29.0864 28.052 -0.275695 2.9096 0.748968 +7254 6 50.692 34.7829 39.7485 29.9384 -8.83369 -9.14761 +7255 4 51.6379 34.6172 39.5245 -10.9597 10.0847 13.0799 +7256 4 50.284 34.1892 39.1195 -14.598 -6.88033 -5.74908 +7257 6 29.205 20.8761 19.5187 12.6622 -8.88768 18.517 +7258 4 30.1458 21.1462 19.5468 -10.0278 2.51211 -7.13483 +7259 4 28.7621 21.2804 18.7794 -5.02457 12.868 -15.5739 +7260 6 45.8413 1.41619 21.3894 -25.1775 13.0352 -19.0829 +7261 4 45.002 1.0285 21.6935 10.996 -3.183 3.42833 +7262 4 46.5512 0.981978 21.8333 16.3199 -17.0363 14.4799 +7263 6 26.0942 5.84138 12.9755 -8.81801 -1.79204 -2.94978 +7264 4 26.5644 5.00851 12.8396 1.48472 -6.22175 2.21387 +7265 4 25.1658 5.65249 12.7519 4.56693 -2.33816 -1.27821 +7266 6 9.00853 19.0479 23.7214 20.279 18.3012 -13.9253 +7267 4 8.07192 18.8993 23.8406 -12.3386 2.44029 -0.494901 +7268 4 9.09287 19.8709 23.17 -6.05991 -16.4473 11.9144 +7269 6 47.699 14.1778 40.0244 8.37408 5.46764 -8.11648 +7270 4 48.526 14.369 39.5365 -13.6583 -0.0280305 9.55934 +7271 4 47.2742 15.0291 40.2237 1.48315 -6.20176 -4.56159 +7272 6 47.9891 19.7944 0.501942 -52.5058 -34.5194 5.9677 +7273 4 48.5389 19.8149 1.25758 31.4646 9.24384 22.8657 +7274 4 47.3233 19.1101 0.79406 16.1078 24.936 -21.6052 +7275 6 27.1644 39.5895 31.4222 -35.4984 -42.2857 -13.2745 +7276 4 26.8828 40.2644 32.0188 2.45392 19.408 13.0965 +7277 4 26.334 39.0158 31.3353 32.2444 14.87 -2.1562 +7278 6 20.718 15.281 27.2921 -20.5288 29.0824 -25.1338 +7279 4 19.7916 15.5288 27.1303 0.0426049 -12.6319 11.5337 +7280 4 21.1251 16.0883 26.9354 13.4588 -8.377 2.43969 +7281 6 53.2931 3.12982 19.6939 21.059 35.3193 6.93312 +7282 4 52.5111 3.68486 19.642 -0.600406 9.66435 -1.15328 +7283 4 52.9649 2.26115 19.6482 -6.97037 -43.0252 -2.92507 +7284 6 40.7577 33.3874 24.037 12.7176 -1.25655 15.6318 +7285 4 41.575 33.1492 24.5319 -10.6485 3.51614 -11.0419 +7286 4 40.1417 32.64 24.1417 6.01104 2.31945 0.566227 +7287 6 50.2034 37.8915 21.3784 34.5696 42.4783 -9.46203 +7288 4 50.977 37.3667 21.5595 20.6596 -6.9612 4.63629 +7289 4 49.5128 37.3071 21.51 -51.1752 -39.6198 7.18684 +7290 6 41.3315 2.34663 21.9881 -5.34027 -0.787955 22.4754 +7291 4 41.3778 2.5308 21.0564 -4.51788 5.59338 -11.8441 +7292 4 40.4369 2.61524 22.307 16.348 -5.18373 -12.1741 +7293 6 3.68887 21.2797 14.3363 -13.7249 24.7693 -29.296 +7294 4 4.1389 21.9084 14.895 6.09004 12.6164 9.74183 +7295 4 3.85532 20.4521 14.7268 10.1618 -35.5887 19.7816 +7296 6 34.2749 11.1621 36.6211 6.86722 -26.3475 -8.98455 +7297 4 34.1457 10.3739 37.2084 1.76529 18.7936 -6.49638 +7298 4 34.0208 11.9523 37.0887 -10.0392 4.20616 19.2695 +7299 6 24.047 21.9251 23.4534 9.96695 -9.01801 9.45846 +7300 4 24.1056 21.4984 22.592 0.489969 -1.19981 -5.95122 +7301 4 24.6049 21.3417 24.0221 -10.3198 12.7259 -7.25629 +7302 6 18.8859 0.355593 4.41703 6.91373 -0.488994 13.8226 +7303 4 18.8848 41.346 4.15992 -3.4937 -3.21088 -8.69706 +7304 4 19.4141 0.350836 5.23016 -4.89519 7.76131 -7.17368 +7305 6 1.61894 7.82812 17.7388 11.0013 -2.20401 0.0755565 +7306 4 1.69825 6.91132 17.4299 0.598176 5.44338 0.144381 +7307 4 0.751076 7.92867 18.1276 -6.88769 -1.80246 0.772288 +7308 6 9.88357 31.5477 26.4865 20.7425 -47.9078 -25.9665 +7309 4 9.77347 30.8406 25.7562 4.13802 32.2768 29.9214 +7310 4 9.16637 32.1481 26.416 -28.5637 22.827 -5.6847 +7311 6 46.9801 33.0031 20.3665 8.92807 -2.6835 25.0439 +7312 4 47.1906 32.5959 21.2783 -12.5238 7.50902 -41.0074 +7313 4 46.473 32.3868 19.8049 3.08737 -2.68707 12.6131 +7314 6 49.5381 29.29 21.3848 5.35466 4.48298 6.61079 +7315 4 50.3596 28.8237 21.4263 11.6576 -22.6485 -14.6982 +7316 4 49.6544 29.7814 22.1942 -19.8316 15.0268 8.13943 +7317 6 13.5135 31.8933 19.1567 20.4477 19.0535 18.7588 +7318 4 12.9544 32.0303 19.9484 11.7182 -3.51681 -10.2564 +7319 4 14.3688 32.3555 19.4049 -26.6747 -15.4769 -10.5401 +7320 6 46.6242 34.0973 16.9259 3.25439 -22.1556 18.333 +7321 4 46.8986 34.1178 16.0034 3.18051 -0.659651 -5.23437 +7322 4 46.9878 33.2447 17.2966 -6.98741 23.2488 -14.973 +7323 6 19.7685 39.5238 2.42723 -1.93992 9.56528 -9.07466 +7324 4 20.504 40.1421 2.55739 -2.20075 -2.41675 -0.557551 +7325 4 19.2228 39.9982 1.75695 7.86662 -14.3322 13.7479 +7326 6 16.5372 9.39399 28.3106 5.81076 4.55242 0.698497 +7327 4 16.5228 10.3583 28.3138 -6.10914 3.2393 2.1867 +7328 4 17.4567 9.2086 28.1181 8.68803 -11.6531 -1.09187 +7329 6 3.04764 33.3834 8.9498 9.15555 8.47462 14.2626 +7330 4 2.34782 34.0603 8.86882 1.18173 -6.7492 -12.1187 +7331 4 3.16543 32.8691 8.13996 -9.91006 6.39371 -6.60301 +7332 6 49.6799 28.314 0.198287 -24.1009 9.02482 3.02524 +7333 4 50.5864 28.3416 41.8577 25.8797 -1.22492 -6.2647 +7334 4 49.539 27.5375 0.746128 -0.431885 -1.84115 5.43874 +7335 6 1.41501 6.84656 30.491 -4.80497 13.9866 22.936 +7336 4 1.80101 7.66454 30.873 3.64878 -10.2221 -13.1962 +7337 4 0.770406 6.61566 31.1883 9.6026 -0.286793 -13.8716 +7338 6 19.7721 9.41455 33.714 -8.86768 10.4812 -29.5452 +7339 4 19.9336 8.45599 33.7164 -2.74186 3.51224 -8.50186 +7340 4 19.4649 9.70036 32.7878 8.54711 -12.9815 34.2723 +7341 6 26.1689 11.9219 3.60877 17.3014 14.1658 -18.8808 +7342 4 25.6285 12.278 4.29668 -11.0155 5.7348 17.6305 +7343 4 26.0891 10.974 3.64129 -4.70103 -13.8965 4.54114 +7344 6 33.2526 2.15457 18.2061 -11.4346 36.8522 -3.73875 +7345 4 32.7853 2.99777 18.4754 10.6797 -23.9754 -11.6278 +7346 4 32.6748 1.45157 18.4903 -6.58847 -5.37306 4.71859 +7347 6 1.56641 29.1164 15.6218 -13.5802 38.9916 52.9136 +7348 4 0.75332 28.6899 15.9164 -2.28927 1.65734 -1.12046 +7349 4 1.88381 28.6368 14.9104 18.6776 -39.2188 -53.7174 +7350 6 41.7212 4.09992 39.5909 -11.2791 25.9615 -27.213 +7351 4 41.4168 4.81457 38.9155 6.653 -41.6332 33.8875 +7352 4 40.9635 3.53859 39.8438 1.60091 7.46224 -7.31473 +7353 6 28.6931 41.7984 21.1891 -6.68751 -8.42641 -4.80462 +7354 4 29.0735 0.780303 21.3271 9.25035 -16.558 -3.13259 +7355 4 29.3834 41.1221 21.0106 -2.7364 22.7931 4.70591 +7356 6 11.6395 12.4176 35.4525 -19.931 13.6599 -6.89173 +7357 4 11.6974 12.2316 36.3791 0.0383878 -4.43782 22.0781 +7358 4 12.5438 12.3774 35.1867 22.2579 1.64914 -11.6458 +7359 6 9.79005 12.0613 0.287125 39.0331 19.741 15.6941 +7360 4 10.6741 12.3652 0.649112 -24.288 -6.9143 -28.8601 +7361 4 9.37178 11.7496 1.07064 -16.9981 -12.0004 12.0483 +7362 6 48.1738 12.4001 9.21087 -14.7098 16.6281 -3.51107 +7363 4 48.3046 11.757 8.50338 5.36034 -5.93883 0.971929 +7364 4 48.886 12.3441 9.8545 11.7295 -7.72549 2.46367 +7365 6 20.1355 24.3829 18.9522 12.9308 -0.734849 -39.1055 +7366 4 19.4937 23.7815 18.5135 12.9255 8.80461 9.87411 +7367 4 20.8069 24.6162 18.234 -21.1698 -7.06963 26.7537 +7368 6 16.5393 31.2961 16.4761 -1.92172 -19.5246 -12.7122 +7369 4 16.66 32.2288 16.679 -4.64409 4.5232 17.4599 +7370 4 16.1207 30.7474 17.1716 1.36469 17.4989 2.94612 +7371 6 1.78169 14.6393 36.2977 19.9207 14.6923 -9.09136 +7372 4 1.03986 14.2937 35.8105 -15.9251 -7.35249 0.645581 +7373 4 1.68132 14.4688 37.2355 -8.64532 -4.94464 12.0587 +7374 6 4.36624 29.2084 29.5903 15.7403 17.1522 -11.4447 +7375 4 4.94475 28.7816 30.2313 0.42296 -3.8665 4.22363 +7376 4 4.9316 29.8996 29.1557 -19.5902 -17.4666 6.54186 +7377 6 43.6839 0.248111 22.6506 -19.7732 -13.3298 -9.50689 +7378 4 42.8764 0.661685 22.3065 0.028666 2.48852 1.60322 +7379 4 43.5183 41.2016 22.5042 11.2477 10.9397 1.57875 +7380 6 52.4994 40.9828 27.2386 -0.538127 -6.12089 -28.931 +7381 4 52.76 40.8447 26.286 -9.02638 3.90908 21.7421 +7382 4 53.2684 41.4137 27.6303 2.05735 4.02476 1.85103 +7383 6 25.5814 23.8969 27.7396 -24.7861 2.98762 0.531627 +7384 4 24.718 24.3642 27.6072 20.4038 -13.4527 4.15226 +7385 4 26.2821 24.4835 27.457 3.8963 1.45656 -1.88052 +7386 6 23.1228 17.031 33.3243 -5.52517 1.23961 5.4323 +7387 4 23.1399 17.5083 34.1558 0.441881 0.23205 -0.480567 +7388 4 22.8557 16.1383 33.5546 -4.67547 -8.64305 1.56256 +7389 6 2.92722 11.8725 21.3561 -41.4423 -19.1296 -19.7046 +7390 4 2.18606 11.2638 21.6443 29.5918 21.1066 -8.34803 +7391 4 3.54191 11.9259 22.0595 17.1072 -0.484489 21.5157 +7392 6 2.18317 4.15265 30.0257 5.779 -9.3787 -10.7468 +7393 4 2.12921 5.11001 30.0802 -2.76576 12.2821 -0.843831 +7394 4 2.67493 3.96573 29.2018 -3.29095 2.88479 4.98522 +7395 6 26.6728 30.2949 13.4768 7.17255 0.654769 14.1147 +7396 4 25.7117 30.2905 13.6467 8.22624 -2.44269 3.31295 +7397 4 27.1112 30.3188 14.3546 -11.9073 -0.623098 -17.8849 +7398 6 24.8734 30.8117 10.8292 -29.6944 -3.60301 -2.53615 +7399 4 25.2254 30.0431 10.3884 7.40196 -6.71761 -6.36825 +7400 4 25.5983 31.2424 11.2381 22.0508 11.6497 12.6203 +7401 6 53.1723 24.107 4.51212 -8.50651 -29.3458 16.902 +7402 4 53.5087 24.8189 4.00388 11.9327 21.9784 -14.7749 +7403 4 53.9335 23.6869 4.92936 2.49868 2.30602 2.88115 +7404 6 24.9006 4.49574 23.9943 -15.2803 12.8054 -1.91421 +7405 4 24.3197 5.26112 23.9044 -17.3839 -11.7779 6.16284 +7406 4 25.6928 4.95696 23.7819 42.3091 -2.82475 -3.31223 +7407 6 34.6808 1.64534 41.2582 -1.16689 -16.4189 -19.1193 +7408 4 35.6107 1.42238 41.0689 -7.35569 3.11738 8.02352 +7409 4 34.6894 2.06091 0.199506 5.11707 10.3461 19.9542 +7410 6 13.3318 19.5273 16.3875 10.456 -31.2285 9.008 +7411 4 13.8245 19.0713 15.6714 -4.89067 6.02882 4.66139 +7412 4 13.1633 18.7854 17.0362 1.8233 23.0525 -16.1268 +7413 6 48.6827 0.169575 20.4108 24.7259 -31.926 -14.6767 +7414 4 49.2893 41.6148 19.7702 -18.6338 21.3246 17.3218 +7415 4 48.933 41.6689 21.2514 -6.5025 5.85221 0.333279 +7416 6 43.0578 27.7881 11.5189 -10.6888 1.76469 -10.0665 +7417 4 42.6538 28.0077 10.6554 5.1393 -6.0393 10.108 +7418 4 43.5199 28.5835 11.7935 3.33621 0.984046 2.36511 +7419 6 25.7084 21.3766 35.1933 7.92601 18.71 -2.37973 +7420 4 25.8037 22.0957 34.5091 -5.30878 -22.9017 16.0752 +7421 4 25.4462 20.5484 34.7558 3.58761 11.0813 -0.636196 +7422 6 44.7325 4.60288 27.7529 -5.18995 0.47983 -9.95788 +7423 4 44.2388 4.02478 27.1463 1.34738 -4.40857 1.63455 +7424 4 44.3371 5.47709 27.6067 3.7052 -1.13476 4.16529 +7425 6 41.2786 11.441 34.2043 -0.416747 21.9122 -5.07112 +7426 4 40.7165 11.5703 33.4237 0.0697438 -4.14349 0.395824 +7427 4 41.2047 10.5155 34.4107 -4.51201 -19.8544 2.93408 +7428 6 19.8751 36.6454 2.03332 12.5662 31.6724 6.60432 +7429 4 20.6794 36.321 2.43856 -1.22315 -24.7147 -1.51883 +7430 4 20.0441 37.6041 2.15193 -20.0718 -8.75186 -9.57731 +7431 6 27.484 4.65653 6.35518 1.28922 -40.4385 -58.6648 +7432 4 27.5497 3.77116 6.72735 -1.75384 3.56143 11.9553 +7433 4 27.4257 5.33486 6.97498 -2.79123 31.4549 44.9969 +7434 6 16.8428 30.7659 39.9509 7.31092 -42.6244 -5.47757 +7435 4 16.9464 31.3097 40.7337 2.60533 1.47109 13.0941 +7436 4 17.1496 29.8303 40.1512 -5.48449 28.5555 1.20442 +7437 6 51.1542 15.2049 16.3406 35.1838 19.4064 -24.6303 +7438 4 51.2473 16.0791 15.87 -9.06363 -20.4986 13.944 +7439 4 52.0128 14.747 16.0894 -33.4595 8.32861 13.6861 +7440 6 49.9911 21.2271 35.9695 16.4294 -24.4585 13.2328 +7441 4 49.3547 21.5056 35.3276 -17.8928 6.13619 -17.6667 +7442 4 49.9245 20.2453 36.0087 2.29216 20.3869 -1.95357 +7443 6 34.4275 0.15221 5.68266 -0.837995 23.3079 0.855413 +7444 4 34.2957 0.929489 6.27037 2.93096 -11.6463 -16.4536 +7445 4 34.3488 0.459476 4.74482 0.623699 -7.30698 18.2278 +7446 6 48.316 11.5365 19.8846 -3.65813 -3.14803 11.8504 +7447 4 47.8503 11.3247 20.7373 6.31016 14.4835 -28.1035 +7448 4 47.7834 12.1052 19.2757 1.33379 -13.4076 20.6299 +7449 6 4.19577 39.4409 13.3607 25.3524 9.34899 10.5928 +7450 4 4.92582 39.74 13.9847 -33.0668 -7.48624 -17.3574 +7451 4 3.31127 39.5736 13.758 11.9971 1.78205 4.76714 +7452 6 8.7457 16.1809 8.53298 -1.62633 17.1572 -22.0575 +7453 4 8.74512 16.8853 9.19115 0.0519099 -7.3494 1.25428 +7454 4 8.72812 16.6658 7.66651 -0.023414 -16.7756 16.7144 +7455 6 29.0271 14.2712 26.5342 -13.8591 45.9397 20.1216 +7456 4 29.0757 15.2697 26.7309 6.93185 -43.1811 -12.6551 +7457 4 28.1042 14.0702 26.7795 9.9397 -3.04712 -3.53591 +7458 6 27.3813 14.5204 8.1419 -14.0666 1.8718 0.247246 +7459 4 26.4091 14.3966 8.10069 17.9482 5.30051 2.04476 +7460 4 27.5539 15.4689 8.31094 -4.76419 -14.5771 -1.3831 +7461 6 14.1301 27.2156 32.9232 24.3629 15.6041 -10.7258 +7462 4 14.926 27.3266 33.4685 -8.09546 -2.45296 -2.52419 +7463 4 13.4702 26.8045 33.4616 -14.5983 -10.6772 12.2116 +7464 6 31.6563 35.7792 21.2709 -29.1401 -25.1051 5.88501 +7465 4 32.0219 36.5153 21.7512 6.27263 14.1007 6.62418 +7466 4 30.8825 35.462 21.8184 22.9209 7.6802 -13.887 +7467 6 54.2186 28.7134 16.8958 -10.3287 11.0002 2.01575 +7468 4 53.5002 28.4234 16.309 3.24852 -2.61584 3.16662 +7469 4 53.9524 29.6107 17.1726 0.515277 -7.78004 -0.375364 +7470 6 9.0512 5.27483 17.1492 25.6572 1.38615 -17.9054 +7471 4 9.89534 5.12229 16.6101 -31.8522 3.085 22.1798 +7472 4 8.85255 6.23494 17.0921 1.81156 -15.0607 2.57474 +7473 6 29.6868 9.77258 26.5671 22.9889 -14.8503 10.4327 +7474 4 30.5444 9.2887 26.5838 -17.3341 11.3615 1.53321 +7475 4 29.3655 9.78642 27.4819 2.88877 -1.07091 -0.346791 +7476 6 44.0288 31.1766 32.1743 -14.2068 1.02328 22.4178 +7477 4 43.2475 30.9789 32.739 9.50682 -2.17476 -16.522 +7478 4 44.5788 31.7142 32.7564 8.88854 3.82935 -1.95952 +7479 6 53.49 3.62433 25.1454 11.2777 4.02107 -26.8953 +7480 4 54.1404 4.33507 25.1993 -2.49783 6.11479 15.045 +7481 4 53.6886 3.29227 24.2489 -10.294 -6.80459 12.4065 +7482 6 12.451 22.8746 3.38821 10.4278 8.96452 22.9237 +7483 4 12.7779 22.025 3.15024 17.1772 -24.972 1.67394 +7484 4 11.7815 22.9738 2.74712 -31.3784 16.165 -21.5343 +7485 6 39.42 29.6871 0.722943 17.2287 20.3893 -0.939439 +7486 4 39.938 29.1007 0.168548 -5.00448 -5.71086 -1.61555 +7487 4 38.6697 29.2119 1.03517 -14.5725 -11.7208 3.22357 +7488 6 13.7451 37.8179 23.0399 -3.65878 -32.3471 -6.65898 +7489 4 14.6418 38.0465 23.3627 -20.7195 15.519 -6.09735 +7490 4 13.1315 38.5597 22.9108 15.1185 11.2609 5.5967 +7491 6 33.3417 41.2334 -0.000336223 20.2285 27.8942 26.4667 +7492 4 33.8463 0.176253 41.7571 -17.5829 -26.3423 -4.93882 +7493 4 33.4991 41.0748 0.960438 -12.6248 -4.93214 -20.7453 +7494 6 15.7246 3.51737 6.33987 10.6879 -4.05507 31.4744 +7495 4 14.9251 3.29652 6.83809 -1.96505 1.65417 1.3128 +7496 4 15.4345 3.71468 5.4634 -8.944 6.24557 -22.4591 +7497 6 27.7713 30.7539 5.06912 -9.69485 -19.9648 -11.4393 +7498 4 28.5319 30.6575 5.66481 -7.77203 -4.90526 -3.90413 +7499 4 27.6074 29.8515 4.67882 9.36195 16.9347 11.4385 +7500 6 13.3277 7.57287 23.3467 18.1651 -5.37845 17.9429 +7501 4 14.1986 7.86136 23.0073 -11.0143 -2.49266 1.50668 +7502 4 12.7134 7.55433 22.6278 -8.93981 2.52131 -14.7715 +7503 6 38.3049 37.3174 27.9983 8.70135 -12.5747 15.655 +7504 4 38.3154 37.3922 27.0572 -6.74668 8.75695 -30.2201 +7505 4 39.0324 36.7087 28.1704 1.61648 -2.88985 11.5174 +7506 6 35.8266 12.5392 12.0897 -2.57405 -7.53067 12.8361 +7507 4 35.6491 11.5922 12.0112 2.97069 1.46586 -4.70523 +7508 4 36.2655 12.8127 11.2954 6.10525 2.83369 -11.8718 +7509 6 52.1153 23.0889 41.2774 53.3714 4.98692 -14.9993 +7510 4 52.5505 23.0114 40.3503 -31.9828 -2.74691 35.5054 +7511 4 51.1752 22.9201 41.2974 -16.3051 -5.99839 -13.4785 +7512 6 39.5458 11.6586 16.6081 -4.87816 2.10267 -34.9091 +7513 4 39.8889 10.7596 16.6462 4.61035 -3.54577 11.4771 +7514 4 39.4661 12.017 17.4857 2.58954 -3.33375 20.5696 +7515 6 0.680688 9.01153 7.97148 24.3969 36.1639 -33.0882 +7516 4 54.7452 9.01592 8.14854 -24.8099 -10.5681 8.91807 +7517 4 1.15172 8.32837 8.40327 2.66278 -26.2854 21.5078 +7518 6 42.3319 28.747 39.482 14.4944 54.9029 13.7373 +7519 4 41.6099 28.5069 40.0315 -24.977 -16.9351 14.372 +7520 4 42.5658 28.0062 38.9777 10.1954 -37.5926 -27.6332 +7521 6 38.7351 30.2774 16.2793 4.0737 2.19128 11.2593 +7522 4 38.8758 29.8829 17.1681 -0.562728 7.98522 -10.8415 +7523 4 39.3736 31.0181 16.2214 -9.64538 -12.7452 3.65311 +7524 6 7.59373 18.0328 0.655349 -39.2466 -13.429 1.02247 +7525 4 7.12412 17.545 1.38102 15.2508 10.2608 -15.5396 +7526 4 8.49503 18.0746 0.920891 28.7098 -1.69475 13.4339 +7527 6 33.7283 34.5883 24.1367 2.81913 -0.677006 -1.55035 +7528 4 33.5209 35.3543 23.5868 -0.36085 -2.23271 3.31185 +7529 4 34.0202 34.925 24.9956 3.1898 -0.550642 -1.12415 +7530 6 16.0108 40.0553 39.5926 -11.937 1.54577 -14.812 +7531 4 16.9471 40.1686 39.433 15.7688 -0.191962 4.71606 +7532 4 15.632 40.0274 38.6953 -1.55756 -1.47356 6.94311 +7533 6 4.49381 37.1265 21.8421 33.1234 -31.7004 -39.5319 +7534 4 4.78916 37.7556 22.4729 8.60512 21.3704 21.7375 +7535 4 5.32421 36.8863 21.3047 -36.9575 7.65083 16.8008 +7536 6 39.2568 20.1405 31.3294 -11.3601 -2.01094 -17.3558 +7537 4 39.2441 20.8952 31.9186 1.64276 10.2876 11.6417 +7538 4 38.6708 20.3662 30.5789 5.24327 3.39586 9.04201 +7539 6 28.5615 6.15748 32.0463 -1.77815 -13.6106 -5.56393 +7540 4 29.3688 6.39317 32.5024 4.03477 3.32162 5.90581 +7541 4 28.0645 6.97719 31.936 3.86184 3.53187 3.02469 +7542 6 9.32925 11.326 38.2021 -45.7357 8.82179 -18.9514 +7543 4 8.63026 12.0506 38.2047 26.1946 -20.5574 6.08922 +7544 4 8.95275 10.6938 37.5333 17.8336 11.1262 12.3014 +7545 6 41.6094 10.4714 6.86105 10.1449 -2.02989 30.4141 +7546 4 41.8033 10.1647 7.80154 -6.16714 11.7455 -31.3638 +7547 4 41.7667 11.4361 6.82819 -2.03628 -11.6206 -3.02795 +7548 6 3.11959 28.1093 17.6239 10.7497 -46.175 24.4008 +7549 4 2.68352 28.5892 16.9552 -19.7085 26.1099 -29.6067 +7550 4 3.57016 28.7359 18.1797 1.91623 14.188 4.79643 +7551 6 39.3448 12.237 19.2548 -14.1137 14.4353 18.1644 +7552 4 39.3198 13.2124 19.4672 -0.23776 -25.4214 -5.72266 +7553 4 38.5957 11.8144 19.7397 13.7352 7.639 -10.0067 +7554 6 2.76578 9.12322 31.711 10.2249 -26.7767 20.5709 +7555 4 3.2959 8.42892 32.18 -23.1647 11.967 -1.06293 +7556 4 3.41205 9.47362 31.1162 6.35119 16.2437 -14.7539 +7557 6 47.0978 34.3186 24.1743 26.4285 -20.6373 22.1669 +7558 4 47.9222 34.8155 23.9694 -26.3889 2.76484 -4.38573 +7559 4 46.3048 34.7125 23.8251 -6.69439 19.4391 -11.1209 +7560 6 41.2781 35.6191 9.5379 -9.82526 -0.200667 -5.59214 +7561 4 40.3156 35.6289 9.77314 20.3165 9.2235 -0.933793 +7562 4 41.677 36.5159 9.62264 -17.3348 -12.0484 0.717846 +7563 6 20.4662 31.4486 3.15039 -21.7086 3.64016 -5.07598 +7564 4 21.0332 31.2208 3.90109 -5.23001 0.711793 3.99895 +7565 4 19.5233 31.6154 3.43158 26.7394 -6.53789 -0.258783 +7566 6 33.2215 17.9623 24.8097 -0.453891 -1.34226 7.30289 +7567 4 34.1788 17.9667 25.0617 -18.0356 9.24084 -3.8919 +7568 4 32.8105 18.8566 24.8334 12.2893 -13.6267 3.75162 +7569 6 40.152 39.887 35.7648 -20.6867 7.32712 26.7748 +7570 4 39.5869 39.7633 34.9934 2.3303 1.35559 2.0998 +7571 4 39.5428 40.1203 36.5292 18.9615 -7.74514 -25.9591 +7572 6 4.86846 34.7127 16.4904 2.99496 1.45153 -7.51648 +7573 4 4.94748 35.6438 16.2302 0.473437 -5.16658 -0.520329 +7574 4 5.67201 34.2663 16.1683 2.12015 0.152524 1.06444 +7575 6 19.1332 11.0374 26.5471 0.604362 14.7011 2.3555 +7576 4 19.0986 10.7741 25.6217 -2.73437 -5.06461 -1.05922 +7577 4 19.4813 10.3027 27.0576 -1.53582 -10.5153 -0.687646 +7578 6 54.0201 13.9196 34.7874 -7.69802 -2.07317 -2.05829 +7579 4 53.0764 13.9769 34.9536 -3.33021 -5.1824 4.14914 +7580 4 54.0417 14.262 33.8952 13.8623 5.56658 -9.2157 +7581 6 1.84699 20.6587 5.20972 14.9439 0.361847 -39.2318 +7582 4 1.3018 19.9191 4.88605 -0.816153 4.45331 11.6833 +7583 4 2.38828 20.8916 4.39492 -13.6739 -1.13034 29.3331 +7584 6 22.2428 0.0912174 14.2544 2.10511 -1.36215 24.2926 +7585 4 21.4939 0.626329 14.4934 -11.4394 6.88953 -7.77601 +7586 4 22.6568 41.86 15.1175 2.53583 -3.69112 -10.285 +7587 6 4.95629 7.04242 24.7427 6.31781 -9.23371 -7.19194 +7588 4 4.17782 7.32111 24.2434 0.969413 4.1364 5.47863 +7589 4 5.24611 6.21648 24.3187 1.32276 5.05146 9.71893 +7590 6 41.4805 20.8726 34.9438 -11.2314 22.7349 11.4525 +7591 4 42.1022 20.1554 34.9949 12.4759 -11.6791 0.0999164 +7592 4 41.5325 21.3468 35.8092 3.20944 -13.6901 -15.0483 +7593 6 28.2157 1.74547 31.725 -9.95228 -2.94536 5.02618 +7594 4 27.5723 1.08944 32.0352 4.54694 0.234407 -12.282 +7595 4 28.3302 2.26918 32.5198 6.68924 9.49254 2.75715 +7596 6 16.8899 27.3746 36.9858 -9.49677 -4.03922 3.2671 +7597 4 17.2157 28.1459 36.4964 2.86939 -7.49192 -2.31982 +7598 4 17.0938 26.5386 36.5152 1.89463 15.2676 -1.69393 +7599 6 26.8243 38.069 8.34482 13.7761 41.6132 3.1747 +7600 4 26.4823 38.3279 9.22598 3.84792 -18.6223 -11.4711 +7601 4 26.785 37.1424 8.19579 -7.88027 -37.9853 9.71444 +7602 6 26.6634 33.7911 23.2273 -21.2745 -8.43567 7.74896 +7603 4 27.1019 33.3181 22.5212 7.04537 -0.372104 -6.32159 +7604 4 27.3305 34.169 23.7872 14.5385 6.50935 5.10733 +7605 6 10.2166 27.1183 30.2276 16.2509 -17.1331 -9.46175 +7606 4 10.1765 28.0583 30.3796 2.29392 15.9864 2.71565 +7607 4 10.9387 26.9511 29.5696 -14.5483 8.58048 15.0042 +7608 6 47.87 12.5975 5.02268 -6.13754 10.9902 -1.31963 +7609 4 48.1357 13.4822 5.34438 -4.36861 -17.8106 0.719643 +7610 4 48.2725 11.9144 5.56853 6.38614 1.6905 7.47062 +7611 6 53.3393 24.5639 22.1523 -40.2275 -1.43509 1.91788 +7612 4 53.1884 24.513 23.11 6.12251 -0.709171 0.80005 +7613 4 54.2538 24.6676 21.944 28.1496 2.10984 1.66559 +7614 6 29.4072 10.7569 19.3822 52.4151 15.8336 -9.71081 +7615 4 29.248 9.98119 18.8618 -10.0643 -15.3346 -6.0739 +7616 4 28.6282 10.9567 19.8417 -45.3483 4.87471 22.9978 +7617 6 39.4757 14.9522 19.5461 30.0359 -1.30311 42.0602 +7618 4 40.386 15.231 19.9108 -38.5728 -7.77311 -23.4682 +7619 4 39.3498 15.357 18.6983 1.75067 15.7407 -16.9704 +7620 6 32.8823 15.9838 22.806 -0.988113 9.61369 -4.64335 +7621 4 32.9657 16.5376 23.5815 3.43203 16.8704 5.79609 +7622 4 32.7087 15.1359 23.1895 -5.55033 -22.0541 3.57771 +7623 6 30.5481 1.96835 21.5144 8.4955 -1.31523 7.25762 +7624 4 30.7645 2.06729 22.4547 -1.5525 1.72807 -3.05596 +7625 4 31.3563 1.607 21.1075 -12.3766 3.94884 0.453046 +7626 6 0.972615 11.9937 3.31932 2.75381 16.0475 9.69945 +7627 4 1.12058 12.9582 3.29011 -6.67466 -9.20629 -8.78254 +7628 4 1.16803 11.7633 4.23669 1.49118 -7.35844 2.879 +7629 6 32.1487 30.4035 20.7885 -10.2937 2.79415 -8.64413 +7630 4 32.9584 30.6778 20.3377 1.19491 2.22071 -1.75985 +7631 4 31.4018 30.7106 20.2304 12.8433 -5.61998 7.3235 +7632 6 5.36663 35.5196 9.0005 -13.7636 -10.8617 -1.51226 +7633 4 5.10558 35.6694 8.09522 3.88385 7.21083 -8.97177 +7634 4 4.84313 34.7327 9.21079 3.19207 0.561776 9.20467 +7635 6 49.9075 13.051 32.2032 24.7068 -1.78611 -22.7634 +7636 4 50.5917 12.8604 31.4934 -20.1594 10.2365 23.451 +7637 4 49.3072 12.3042 32.1357 -5.12737 -3.80929 6.93874 +7638 6 4.31321 24.0956 1.58545 -15.4175 -15.0012 -21.2972 +7639 4 3.62325 24.7374 1.73273 -2.73087 12.0747 8.21305 +7640 4 3.96758 23.5799 0.823479 15.3265 9.07188 13.8923 +7641 6 44.1581 38.1227 12.3545 -1.42535 -29.4608 0.820402 +7642 4 43.4877 37.5183 12.7749 7.78878 22.0847 -6.23147 +7643 4 43.9706 39.05 12.5061 -8.83193 8.8938 6.46859 +7644 6 44.688 17.3349 22.7943 52.857 -4.21013 7.29678 +7645 4 45.2391 18.0521 23.242 -20.6522 -19.8992 -14.1432 +7646 4 45.3699 16.6167 22.57 -26.4285 25.231 9.0384 +7647 6 20.3608 11.6914 19.667 7.58964 -15.1508 -20.1027 +7648 4 20.0231 12.466 20.0832 -9.22037 21.7722 17.9466 +7649 4 20.541 12.011 18.7627 0.78957 -9.8802 4.31695 +7650 6 4.45783 15.4051 36.2022 4.17523 -10.6616 -1.13379 +7651 4 5.07913 14.7124 35.8925 -4.22209 9.46347 0.0108161 +7652 4 3.57023 15.0045 36.1544 3.18966 5.51307 1.04981 +7653 6 44.8105 39.5245 30.1712 -12.2097 -12.5983 -29.4865 +7654 4 44.6649 39.2374 29.2388 12.2423 8.81859 19.2473 +7655 4 44.0848 39.0946 30.6384 -0.298867 5.38951 7.86823 +7656 6 30.0635 3.50956 11.3278 16.0802 -2.39158 -40.3094 +7657 4 30.5444 4.30508 11.007 -11.8296 -5.04519 20.5985 +7658 4 30.1379 2.92562 10.5291 -8.6007 1.99314 24.6663 +7659 6 25.6288 24.8657 16.1423 35.3146 -5.68436 -0.158812 +7660 4 26.5897 24.7732 15.9989 -9.69879 -4.30362 -13.2764 +7661 4 25.6615 25.1054 17.0605 -14.6317 7.6504 23.2411 +7662 6 36.8074 29.8609 20.6529 -16.3286 -4.81766 17.6852 +7663 4 35.9316 30.2459 20.3982 14.0867 -8.19012 9.60149 +7664 4 36.7164 29.3161 21.4988 -1.56746 21.2483 -31.978 +7665 6 52.2273 17.0565 38.3075 -18.6216 -30.1938 15.1193 +7666 4 51.4912 16.4635 38.6201 23.7372 14.7716 -7.00173 +7667 4 51.7959 17.5937 37.6524 -0.777677 7.661 -6.77585 +7668 6 3.82637 23.6296 29.8591 26.0466 24.015 14.1033 +7669 4 4.67122 23.3872 29.4436 -4.98409 -4.75234 -2.50433 +7670 4 4.14214 24.3103 30.5173 -20.0237 -17.5461 -14.7603 +7671 6 6.36694 19.9104 41.0994 -7.87156 6.69529 -0.551213 +7672 4 6.75531 19.2216 41.6418 3.91706 -4.8357 7.00798 +7673 4 6.43687 20.7189 41.61 0.371167 5.3541 9.12827 +7674 6 28.9069 38.9219 35.3342 18.1363 5.4885 19.4373 +7675 4 28.4975 38.2544 34.8057 -13.0204 -17.6003 -18.1497 +7676 4 29.7244 38.4883 35.6529 -6.84193 6.3312 -4.3373 +7677 6 1.06391 30.294 34.4744 17.4659 -4.25802 33.126 +7678 4 0.923806 29.8092 33.6831 -4.92213 -16.9626 -31.6436 +7679 4 0.43107 31.0027 34.4841 -13.3738 11.5818 -2.38269 +7680 6 26.4433 22.0338 20.438 10.4135 -19.5508 3.73058 +7681 4 27.3849 22.2767 20.3653 -17.5193 8.20183 -1.91668 +7682 4 25.8117 22.75 20.2981 5.30742 7.62512 -2.77887 +7683 6 3.9439 18.647 22.686 19.6053 -30.212 14.064 +7684 4 4.76982 18.631 23.2404 -22.0254 9.00566 -12.7221 +7685 4 3.71052 19.5535 22.5456 -1.30938 28.7031 -1.82281 +7686 6 6.87955 39.3273 26.9921 -1.67667 -12.9446 -11.9216 +7687 4 7.1836 39.9129 27.6984 -12.429 3.42242 7.34442 +7688 4 5.90054 39.2886 26.9896 13.9064 15.8094 12.8698 +7689 6 43.976 41.7556 26.5281 4.8347 -4.89589 -5.39334 +7690 4 43.9038 0.242071 27.3891 4.48323 5.1383 20.2804 +7691 4 43.1144 41.9148 26.1591 -17.5097 2.26447 -13.804 +7692 6 31.7137 29.57 16.9845 -29.8695 1.84649 5.70955 +7693 4 31.0051 28.8814 16.8861 15.511 13.0746 -1.88966 +7694 4 31.2475 30.3377 17.3963 12.872 -19.7765 -2.8161 +7695 6 46.2467 10.9544 15.5549 14.6537 -15.0388 13.4913 +7696 4 45.2992 10.7621 15.4719 2.35584 -6.3837 2.44855 +7697 4 46.7422 10.1008 15.6673 -18.7057 18.8904 -8.1417 +7698 6 36.5806 15.025 25.8165 21.8026 1.76557 9.13915 +7699 4 37.3648 15.4873 26.2149 -21.7037 -15.0217 -10.3096 +7700 4 36.1201 14.6319 26.5704 -2.31195 -1.95921 2.19148 +7701 6 47.2758 22.6707 6.12549 -20.393 21.5378 -17.5673 +7702 4 46.5536 23.2672 5.80637 16.9751 -15.6011 5.88158 +7703 4 47.0174 22.4855 7.02503 2.56882 -3.04752 8.65489 +7704 6 27.5281 39.6653 17.8063 9.11062 13.5998 -14.667 +7705 4 26.6008 39.6971 17.5421 -9.18871 -3.65478 0.40423 +7706 4 27.5952 39.1072 18.5692 -4.91094 -8.97362 13.813 +7707 6 14.0432 27.9674 36.8911 6.42031 -13.692 3.20322 +7708 4 13.4093 27.2386 36.6831 22.3711 16.0651 -1.21324 +7709 4 14.9745 27.6178 36.9209 -23.5128 3.35359 -2.56993 +7710 6 33.7582 13.0225 13.8549 2.82411 10.3644 -10.1378 +7711 4 34.6192 13.1187 13.3682 -26.1927 -14.0119 11.7219 +7712 4 33.447 12.1034 13.9061 16.5995 3.21583 -3.74575 +7713 6 3.39066 17.4794 1.96807 -11.027 -24.2448 -29.9928 +7714 4 3.01559 16.7425 1.36999 17.4474 35.7284 24.3857 +7715 4 3.43148 18.2603 1.39088 -0.910914 -5.0095 5.82543 +7716 6 27.5636 2.76805 36.4448 23.3016 6.40537 7.49337 +7717 4 28.0874 2.94382 35.6362 -14.0128 -4.70143 5.95918 +7718 4 26.7201 2.39292 36.1778 -1.1877 -0.145823 -5.22631 +7719 6 21.3174 1.20043 18.721 3.60184 -34.5623 26.1973 +7720 4 20.9731 2.06802 18.64 -8.90193 33.3239 -10.7294 +7721 4 20.989 0.903829 19.6038 6.52339 -1.5964 -17.0558 +7722 6 11.8953 16.678 29.2972 -24.0209 -12.1876 15.7906 +7723 4 10.9907 16.5502 28.9196 20.2967 4.53139 4.03679 +7724 4 11.83 16.2797 30.2084 5.50538 14.3948 -24.2902 +7725 6 15.9723 29.4609 29.6333 0.682268 26.1612 18.9471 +7726 4 16.8848 29.3174 29.3467 -1.47573 8.2327 2.84191 +7727 4 15.9822 30.2485 30.2615 3.64459 -27.0302 -18.4378 +7728 6 42.9269 7.03734 4.5197 11.663 -6.03152 6.53833 +7729 4 43.4231 7.50219 3.8104 -1.91258 -11.2042 14.7177 +7730 4 43.564 6.5391 5.10838 -14.9069 13.4822 -19.2581 +7731 6 46.4099 26.3175 18.5001 -14.65 2.77244 -10.2078 +7732 4 46.6739 27.1133 19.0164 -10.4759 -17.1195 -12.5948 +7733 4 45.7242 26.5969 17.8403 16.3643 -1.95791 15.5671 +7734 6 26.8576 31.9381 30.1176 11.4414 -26.9795 -35.8502 +7735 4 27.1259 30.9869 29.8859 -9.79711 36.6724 15.314 +7736 4 26.5998 32.3006 29.2227 5.46388 -10.7605 29.9307 +7737 6 19.4818 37.6192 31.2596 -32.5143 -22.3469 33.0613 +7738 4 19.0962 36.8501 30.8088 8.72557 8.52431 -5.84089 +7739 4 19.0944 37.5229 32.1795 16.9146 13.3756 -22.466 +7740 6 52.3665 32.7318 12.7942 -5.34222 7.33615 -3.08781 +7741 4 51.884 32.8768 11.9489 17.9119 0.95058 7.1847 +7742 4 53.27 33.1068 12.8183 -18.0778 -3.45769 -11.3622 +7743 6 6.73992 9.26339 24.0285 -18.4022 -33.2824 -0.456279 +7744 4 6.43016 9.52976 23.1488 2.39009 0.543925 -1.37305 +7745 4 6.14044 8.50785 24.2751 15.0572 15.2043 -3.93749 +7746 6 39.7373 39.5658 25.499 -11.0807 -5.52867 0.517577 +7747 4 39.7453 38.628 25.2585 2.77876 5.57729 -0.31401 +7748 4 38.826 39.699 25.8216 4.65786 0.889055 -1.26295 +7749 6 24.0734 14.0105 21.1438 13.9648 5.3121 -25.5312 +7750 4 23.6065 13.6215 21.8839 -3.42696 -11.6299 6.48748 +7751 4 24.3304 13.3134 20.491 -9.48085 14.6929 20.6508 +7752 6 5.1987 41.7736 24.8713 10.0047 -19.0707 10.1325 +7753 4 6.05769 0.0475547 25.2635 0.547146 -1.74599 -5.91735 +7754 4 4.86042 0.69526 24.5593 -4.41349 12.4443 -5.8689 +7755 6 42.3687 20.86 21.2777 19.2234 -22.1312 -1.40502 +7756 4 42.3783 20.5581 22.1846 0.624409 -1.73106 8.2154 +7757 4 41.7113 21.532 21.2665 -20.5735 20.428 -5.9858 +7758 6 48.2425 15.3687 33.5924 -0.241089 -2.38933 -5.28694 +7759 4 48.6415 14.7162 33.0072 6.18243 -4.87195 3.86709 +7760 4 47.6596 15.8553 33.0028 -7.11438 7.34599 -0.780278 +7761 6 46.0202 38.2953 16.5865 15.7829 17.4793 7.01852 +7762 4 46.7193 37.7552 17.0318 -13.8218 15.7663 -8.05182 +7763 4 46.1673 39.253 16.8241 -2.73609 -24.364 -6.22008 +7764 6 4.62701 28.4898 21.3631 -35.4199 -38.8764 -1.71187 +7765 4 5.05003 28.7578 22.1614 14.3175 13.903 20.3467 +7766 4 4.23296 27.6059 21.6238 11.0236 23.568 -16.8729 +7767 6 20.5692 15.1618 18.3974 -2.72234 -3.16682 18.7699 +7768 4 20.0205 15.9086 18.1633 -0.374776 9.93651 -8.10169 +7769 4 20.1114 14.8073 19.1799 7.71486 -3.14336 -3.02048 +7770 6 16.2446 13.6415 17.4737 -35.4034 4.06645 -23.9936 +7771 4 16.1835 14.6144 17.5029 6.20848 -12.1 -0.082548 +7772 4 15.5556 13.4035 16.7727 24.4056 2.85778 27.0666 +7773 6 52.5084 30.9566 18.1567 -0.97573 -12.5044 17.346 +7774 4 52.0533 31.4717 17.4985 -6.50351 10.4198 -16.9401 +7775 4 51.7821 30.6074 18.6971 11.4062 2.54252 -4.46582 +7776 6 24.418 1.73203 15.7939 2.07222 -10.1482 7.47229 +7777 4 24.2447 1.14878 16.5739 0.390494 16.7143 -9.44633 +7778 4 24.1366 2.64887 15.952 -0.929678 -6.23215 5.34629 +7779 6 23.8719 5.08832 31.0744 22.7283 -21.9769 -16.2257 +7780 4 23.8146 5.92648 31.5054 -7.3092 22.9653 9.22328 +7781 4 24.8319 4.92382 30.9303 -16.6577 0.531409 1.66203 +7782 6 29.6615 30.9343 0.410524 16.5859 -5.2272 -6.83283 +7783 4 30.4171 30.5602 -0.0763344 -8.98044 0.909776 12.9407 +7784 4 29.1293 31.2514 41.5907 -13.3941 8.54792 -1.14443 +7785 6 32.8591 37.9003 22.5268 -10.9299 -3.56267 -2.34485 +7786 4 33.7082 38.1164 22.1304 5.81458 1.66065 7.83892 +7787 4 32.835 38.1832 23.4516 6.53001 6.08896 0.386172 +7788 6 16.4762 17.3653 33.758 -11.7596 5.685 -6.41316 +7789 4 15.9639 18.0545 33.2621 15.6067 -10.6469 10.7903 +7790 4 17.1589 17.009 33.1621 -6.01342 7.59956 -1.04496 +7791 6 9.22918 13.3839 27.5418 -13.213 -9.30661 16.5651 +7792 4 8.30942 13.5198 27.2923 -4.71042 4.84624 -13.6557 +7793 4 9.0972 13.1179 28.4658 14.0632 -0.809421 3.61995 +7794 6 43.4685 7.73978 17.2176 -8.6426 5.21856 8.44668 +7795 4 43.4054 7.77113 18.1985 3.14312 -1.73226 -22.4674 +7796 4 44.4071 7.82788 17.0033 -0.931382 -0.0897333 1.197 +7797 6 22.3132 24.3412 23.1703 -9.75348 13.1727 -0.0757149 +7798 4 22.7871 23.5122 23.2675 1.8966 -9.89464 -1.11237 +7799 4 21.5045 24.1854 22.6454 4.5924 -1.52242 4.18414 +7800 6 26.0037 32.9236 32.716 -4.33416 -0.788049 -7.61174 +7801 4 26.2455 32.6516 31.8136 -0.0498336 0.850388 -0.133699 +7802 4 25.1949 32.4304 32.9126 -0.360701 -0.787143 2.76329 +7803 6 16.9426 19.041 7.45715 -3.10994 24.472 -2.41526 +7804 4 16.308 19.3093 8.14456 3.13816 -6.91205 -2.30089 +7805 4 17.0114 19.8381 6.87129 1.57938 -24.3813 10.2947 +7806 6 48.1131 14.4569 27.5699 7.08917 8.35207 6.49885 +7807 4 48.0603 15.1245 26.8691 -1.5138 -4.18476 1.16992 +7808 4 48.1537 14.9494 28.4126 -1.96213 -3.76556 -9.73571 +7809 6 52.3834 41.7541 11.1123 -0.447482 12.3 22.2377 +7810 4 52.3153 0.228199 10.2442 -0.817032 7.00513 -16.5207 +7811 4 52.6623 0.571857 11.7011 -4.41087 -5.87968 -8.23494 +7812 6 36.3325 6.93202 12.7048 -8.66608 5.7588 -1.53482 +7813 4 36.3873 7.88419 12.9074 5.41886 -9.49824 0.0534512 +7814 4 37.2464 6.6206 12.6662 3.93968 -0.5832 -0.272047 +7815 6 8.24609 20.3242 16.6676 2.28714 -8.73249 -3.11806 +7816 4 7.99607 19.3797 16.5602 0.915774 9.85224 4.30221 +7817 4 9.21956 20.3717 16.6442 -3.81833 -2.78155 -1.09608 +7818 6 28.8059 40.3215 12.8316 -6.32157 -2.99739 9.80695 +7819 4 29.5356 40.2333 12.2314 15.0973 -2.52646 -11.1155 +7820 4 28.4555 39.4209 12.8947 -4.4969 5.39171 3.74805 +7821 6 18.1648 11.8204 16.9538 6.42365 10.4423 10.6103 +7822 4 17.6537 12.6149 17.1793 -7.21931 -10.1359 -1.31065 +7823 4 19.063 12.1656 16.925 9.05203 -3.86377 -1.18548 +7824 6 30.8803 17.4233 21.4874 -38.9186 -21.5127 -11.6054 +7825 4 30.1793 16.7188 21.4067 15.4039 25.3522 4.50617 +7826 4 31.5864 16.9116 21.8642 20.5617 -1.86838 10.7411 +7827 6 34.8073 19.4112 37.959 10.4013 19.2527 -16.7989 +7828 4 34.9062 20.1671 37.3279 -0.177011 -16.5385 16.965 +7829 4 34.2544 18.768 37.5084 -3.31564 -7.45818 -3.12702 +7830 6 35.8251 16.8879 29.2053 19.9429 8.12055 25.1888 +7831 4 36.604 16.4922 29.6427 -6.21008 5.15879 -2.88988 +7832 4 35.5164 16.1914 28.6524 -12.7517 -21.289 -18.0185 +7833 6 3.03682 32.2806 6.33235 -9.22618 28.6071 10.2197 +7834 4 2.10307 32.1357 6.11945 6.4331 -12.4482 -1.5948 +7835 4 3.56193 31.5065 6.1559 2.8275 -21.5224 -7.32445 +7836 6 26.8 41.6522 10.1614 16.4152 -10.6242 6.62789 +7837 4 27.6763 41.4103 9.75871 -19.2491 6.11251 13.5217 +7838 4 26.9685 0.0827479 11.0562 4.26354 0.263175 -7.76775 +7839 6 52.2755 24.564 24.8743 -17.4742 4.09161 11.4913 +7840 4 51.3068 24.6875 24.9545 12.6777 -6.48001 -7.54331 +7841 4 52.5704 24.9086 25.7267 7.88636 1.59704 3.61539 +7842 6 22.6859 22.6471 33.5865 3.00815 -0.389016 -3.70522 +7843 4 23.2377 23.2516 34.129 -18.2936 -9.34398 -1.8364 +7844 4 21.8798 22.3666 34.0572 9.18357 8.33181 5.74035 +7845 6 10.6559 14.2334 33.0439 8.40108 -6.88321 -2.71679 +7846 4 10.5166 14.9368 32.4181 8.42324 10.9453 -12.1325 +7847 4 9.76709 14.0756 33.3137 -17.8131 -11.8211 11.2552 +7848 6 21.913 10.8504 11.5417 10.0273 5.1408 -10.1307 +7849 4 22.8643 10.6911 11.6864 -4.5907 0.219491 7.97275 +7850 4 21.4519 10.7503 12.3817 3.5408 -3.26695 13.1151 +7851 6 38.3604 6.02409 25.8423 -7.72295 28.2176 13.9057 +7852 4 38.0159 6.28095 26.7202 2.23326 -16.155 -4.56644 +7853 4 38.4362 6.90267 25.4438 5.48615 -7.56939 -11.5178 +7854 6 30.9465 26.6393 38.5732 9.04128 -30.5088 -25.1958 +7855 4 30.9128 26.4505 39.498 -1.67119 3.99535 28.8865 +7856 4 31.0441 25.726 38.2186 -4.36445 16.9712 0.749916 +7857 6 30.1667 14.6301 35.4838 10.1392 5.1159 -4.4805 +7858 4 30.5216 15.3681 34.9096 -25.1579 -14.4294 10.0398 +7859 4 29.1929 14.5877 35.5299 11.6839 11.6021 -8.75286 +7860 6 12.5351 37.2243 16.9695 -17.9994 -5.54058 0.759354 +7861 4 12.9667 37.9067 17.4519 9.84296 27.0859 15.3185 +7862 4 13.2146 36.5653 16.9126 10.1753 -19.489 -6.1469 +7863 6 27.4306 21.5582 37.7184 0.323044 -0.91237 -2.80926 +7864 4 26.8919 21.7087 36.9418 -1.95891 -4.49412 -14.6911 +7865 4 26.9535 22.0297 38.3943 0.198826 4.23191 11.3586 +7866 6 29.6082 18.3788 12.6829 -3.7237 -11.7076 25.6006 +7867 4 29.4829 18.1024 13.618 2.9495 3.49705 -16.1413 +7868 4 28.7034 18.5321 12.3984 -4.77545 3.00323 -3.28229 +7869 6 2.3585 15.6468 0.175999 -8.20612 37.5639 57.3692 +7870 4 1.52386 15.5898 41.6501 -20.1916 -9.73007 -21.8008 +7871 4 3.00191 15.1099 41.6903 28.5072 -35.3577 -30.6151 +7872 6 17.8194 25.7234 4.22068 -18.7286 -4.35761 2.03057 +7873 4 16.8619 25.5897 3.93795 36.6055 5.10926 -2.3659 +7874 4 18.4291 25.8425 3.4621 -13.2431 -0.0346718 7.72723 +7875 6 41.7912 11.1794 20.2704 -4.7703 -4.22644 -3.97484 +7876 4 42.5222 11.2179 19.6258 -6.77094 -1.14571 2.2342 +7877 4 40.9861 11.4636 19.8126 1.73275 2.14556 -1.92771 +7878 6 38.0378 18.3863 24.0278 -3.74133 -10.331 -0.132081 +7879 4 38.4309 19.0888 24.5482 3.22643 8.24914 5.57345 +7880 4 37.9308 18.7305 23.1431 0.767244 4.53126 -6.25669 +7881 6 4.13298 13.9173 33.7521 30.6843 -35.3272 -10.2657 +7882 4 3.2388 13.7394 34.0326 -6.45696 -6.01886 0.999898 +7883 4 4.62487 13.0231 33.6052 -30.6419 39.0128 7.66426 +7884 6 19.1936 19.1847 26.5022 -1.72621 -3.50471 2.07629 +7885 4 19.5259 20.0399 26.2155 5.41694 7.89262 1.74938 +7886 4 18.9505 18.7515 25.6854 -0.500338 -7.01675 -4.74744 +7887 6 22.475 26.1945 25.3345 -21.4458 -23.9003 -3.16659 +7888 4 22.3709 25.4906 24.6814 -7.32491 -4.57374 0.352876 +7889 4 23.3013 26.5414 25.0733 33.537 19.6696 -4.44151 +7890 6 48.8098 32.073 32.5556 -12.1052 4.48194 -0.190297 +7891 4 48.9381 31.1381 32.4233 -5.03309 -16.3747 0.495313 +7892 4 49.6354 32.4434 32.2762 12.9514 12.9364 -2.07298 +7893 6 25.2177 18.014 27.013 4.13139 4.11129 3.02633 +7894 4 24.4991 17.5573 27.49 6.6231 -0.568789 -7.074 +7895 4 25.6482 17.4406 26.3525 -8.92874 -1.57445 7.95973 +7896 6 1.76475 41.5608 24.9549 2.89162 -9.06076 -21.1384 +7897 4 1.88611 40.794 24.3317 -1.07403 19.5272 24.3581 +7898 4 1.30092 0.287142 24.3881 5.67761 -7.93757 11.1942 +7899 6 18.6633 11.7702 10.8608 -14.1102 -15.1967 11.3789 +7900 4 19.5021 11.9001 10.4051 -2.67857 -1.17934 -0.0567829 +7901 4 18.6465 10.841 11.1975 0.382459 20.6246 -9.54243 +7902 6 45.6242 16.5573 4.85031 17.0541 -2.39304 -3.72853 +7903 4 46.5701 16.2411 4.85652 -23.9929 13.0597 -1.64852 +7904 4 45.6057 17.5078 4.58964 5.38323 -15.7737 4.77093 +7905 6 40.6798 36.3894 24.0177 5.99482 15.2006 -18.5281 +7906 4 40.7505 36.8152 23.1136 -3.68852 -16.1642 25.9152 +7907 4 40.7388 35.4259 23.9735 0.360603 0.79119 -4.57544 +7908 6 32.2161 36.322 4.9431 5.19197 18.2152 11.0878 +7909 4 31.5074 36.1415 4.30154 10.9387 -10.0795 -6.57323 +7910 4 33.0257 35.7839 4.88769 -13.0089 -6.05715 -7.93038 +7911 6 1.60369 14.6754 10.8168 -10.3056 7.30247 33.6992 +7912 4 2.33423 15.3134 10.9307 -7.1595 -6.86026 -1.25923 +7913 4 1.1476 14.6845 11.711 13.0511 -0.847163 -26.6328 +7914 6 35.0153 14.2871 28.0739 18.7596 2.69464 30.5166 +7915 4 34.8734 14.0618 29.0187 14.279 3.49385 -12.2543 +7916 4 34.1456 14.1907 27.7398 -26.4062 -1.19123 -20.5956 +7917 6 54.7157 6.11907 21.8609 -12.1949 -7.16094 1.89291 +7918 4 53.7846 6.03827 22.1577 10.7478 1.95047 -3.13077 +7919 4 0.0370646 6.90146 22.3147 2.89466 7.98076 3.79048 +7920 6 31.7642 16.9274 27.3665 -7.54316 -5.52924 6.90942 +7921 4 30.8348 17.1206 27.2023 -9.34166 0.83246 -0.0222557 +7922 4 32.1928 17.2544 26.5838 13.9998 7.82105 -16.2222 +7923 6 14.4504 28.0052 11.1087 -4.71237 -14.6735 4.6077 +7924 4 14.1081 28.8557 11.3451 -9.65694 14.7183 8.34222 +7925 4 14.826 28.1745 10.2406 5.25389 -7.26775 -5.19981 +7926 6 35.6627 19.4906 18.309 1.38743 3.66357 1.00844 +7927 4 36.0608 19.4502 19.1905 -8.3289 1.62604 -1.04031 +7928 4 34.971 18.8114 18.299 7.41978 2.58016 -0.85803 +7929 6 0.908295 12.7232 15.4509 -10.2874 -45.1283 5.64528 +7930 4 0.635795 11.7526 15.3361 10.0925 35.0181 2.47128 +7931 4 1.39513 12.719 16.2997 -3.76012 1.73199 -7.91518 +7932 6 52.7239 14.8052 20.9911 -10.1838 -50.8962 13.8805 +7933 4 52.1355 13.9729 20.9263 20.4043 37.1153 -0.0771148 +7934 4 52.3678 15.481 20.4204 -9.75671 2.85516 -9.21068 +7935 6 7.50014 6.78453 13.6112 45.6118 -3.77462 -0.237279 +7936 4 7.66407 7.72531 13.7166 -11.095 5.64184 -2.33744 +7937 4 8.44113 6.46934 13.5548 -33.3093 -4.56257 -1.46213 +7938 6 12.8693 29.1327 30.951 -35.1999 43.7452 -37.9705 +7939 4 12.911 28.5157 30.2274 6.73286 -14.9776 0.757022 +7940 4 13.2432 28.8129 31.7306 26.8069 -31.1286 39.1504 +7941 6 8.91269 29.9946 35.6682 4.82638 -20.5676 13.9142 +7942 4 9.08199 29.9869 36.6487 -3.4848 12.9743 -23.6701 +7943 4 8.85763 30.8835 35.2999 2.4913 8.97671 5.8399 +7944 6 29.2501 7.21193 5.56384 -35.3124 23.3999 -5.45769 +7945 4 29.8929 6.567 5.7677 24.3163 -25.3556 4.38867 +7946 4 28.4878 7.00912 6.14468 16.2636 8.35776 -7.44031 +7947 6 25.8882 9.2493 3.85609 -10.1418 -10.3657 2.14015 +7948 4 26.6938 8.77544 3.58522 -5.62061 -1.52714 -0.987441 +7949 4 25.143 8.71761 3.5088 14.4855 4.13341 2.07026 +7950 6 46.1828 19.5303 23.8452 27.5142 -8.79556 18.2338 +7951 4 47.0303 19.3932 24.4147 -29.6641 11.3761 -34.952 +7952 4 46.4302 19.9015 22.9687 10.0609 -5.49214 13.8961 +7953 6 18.6 35.3226 28.7813 33.9262 -21.2248 5.29661 +7954 4 18.5078 36.1255 28.2543 2.15121 5.76995 -5.3877 +7955 4 19.5645 35.0126 28.755 -37.0827 17.274 -2.06568 +7956 6 28.0068 22.625 32.1882 17.1638 -9.71048 -11.652 +7957 4 28.1161 23.0799 31.3381 -0.933036 0.686599 6.01892 +7958 4 27.1717 22.9224 32.5558 0.319614 0.839726 2.26602 +7959 6 25.9992 18.4251 22.6716 -8.51512 -6.6596 14.3523 +7960 4 26.8098 18.8237 22.3895 20.3106 6.57833 -11.9809 +7961 4 25.8253 18.8771 23.5162 -1.041 -7.57666 -6.79729 +7962 6 31.1689 23.0872 29.1831 -2.26749 -18.4759 6.78914 +7963 4 31.118 22.1592 28.8841 -5.05583 5.59361 3.05947 +7964 4 31.7418 23.5345 28.5581 5.1573 7.79625 -4.49352 +7965 6 36.6391 4.9259 0.480345 37.9344 10.2065 -26.5572 +7966 4 36.638 5.82198 0.886244 0.658013 -14.6584 -5.92388 +7967 4 37.39 4.95173 41.699 -35.1456 1.42767 30.4358 +7968 6 36.484 21.0145 10.0529 -6.00883 6.48187 8.17175 +7969 4 36.4042 20.1763 9.58301 3.63574 2.58382 -3.15576 +7970 4 35.8773 20.9259 10.8015 2.14778 4.06152 -0.936887 +7971 6 50.5993 25.1947 18.3919 -28.2028 12.9956 8.35013 +7972 4 49.869 24.7394 17.9262 9.19638 1.46827 3.55355 +7973 4 51.4482 24.8993 18.0848 11.0575 -8.08323 -5.33222 +7974 6 50.1824 39.6576 12.4356 -22.7811 -7.9912 15.1349 +7975 4 49.7705 38.7879 12.6194 4.75387 11.043 -2.88475 +7976 4 51.0686 39.4751 12.1603 15.8621 -1.53988 -6.37666 +7977 6 30.5412 12.4178 4.80566 -15.3128 -2.78075 25.3711 +7978 4 30.0752 11.5776 5.01806 10.6669 11.6172 -5.90727 +7979 4 31.021 12.2424 4.01172 11.531 -8.83371 -18.4272 +7980 6 28.9525 15.4713 21.8679 -2.36978 -36.4192 26.6063 +7981 4 29.1677 14.6271 22.3934 -7.66269 33.2693 -19.6276 +7982 4 28.1632 15.8063 22.3348 7.54721 -2.84859 -11.2752 +7983 6 14.0684 9.5583 16.997 2.7235 -6.59901 -0.744295 +7984 4 14.8185 8.94582 17.0717 -0.0957791 5.7783 -3.11218 +7985 4 14.4323 10.4488 16.9992 1.00571 2.57913 -1.39277 +7986 6 4.48903 30.1743 11.858 18.777 -10.7052 13.2768 +7987 4 4.86699 29.7697 12.6847 -17.3276 7.96894 -17.1216 +7988 4 3.53137 30.2861 11.9207 -0.113543 -0.314347 4.01346 +7989 6 40.8874 8.0652 23.6541 0.993335 -18.0149 -24.6412 +7990 4 41.0014 8.23968 22.6934 -0.45004 7.6784 15.1082 +7991 4 40.7726 7.0925 23.6399 1.20374 9.92563 8.58777 +7992 6 53.7462 35.0557 16.7061 9.98011 -4.48961 -22.2856 +7993 4 53.4827 35.8182 17.2307 0.000554802 6.10184 -1.96461 +7994 4 54.0786 35.3449 15.8213 -7.68991 -0.599931 23.4559 +7995 6 53.7073 10.1889 20.3718 -10.7517 16.2467 -19.4493 +7996 4 53.8408 10.0262 19.4272 8.41512 -10.415 5.03553 +7997 4 53.1338 10.9644 20.2967 0.731263 1.06205 11.7435 +7998 6 4.58979 27.075 7.78807 17.6653 -15.6715 -1.75621 +7999 4 5.19096 26.32 7.80399 16.3727 7.79792 -3.24405 +8000 4 3.78382 26.6199 7.94519 -28.415 1.42755 3.38346 +8001 6 50.5066 22.5306 22.1436 -1.2339 18.6921 5.41009 +8002 4 50.2802 23.3104 22.6632 -2.8343 -11.09 7.6214 +8003 4 50.7991 22.9414 21.3369 4.56213 -7.53044 -15.8119 +8004 6 7.04346 27.196 21.628 9.41144 -9.96736 11.8657 +8005 4 6.8407 26.6883 22.4668 -8.25713 16.2835 -27.3312 +8006 4 6.26031 27.4748 21.116 4.26862 -9.43237 15.0117 +8007 6 23.8265 35.0499 16.5937 18.3012 9.13896 26.4348 +8008 4 24.7235 34.8381 16.9269 -14.9485 7.62278 -2.13189 +8009 4 23.7604 34.5968 15.7714 -3.77201 -11.7597 -22.7393 +8010 6 5.98953 23.8983 3.91761 -44.4181 -14.5448 -1.98234 +8011 4 5.398 23.9519 3.1318 15.794 0.401012 8.45254 +8012 4 5.35617 23.6012 4.61938 19.6174 4.72778 -5.04958 +8013 6 38.7401 25.0729 19.1247 8.8169 4.91643 10.7802 +8014 4 38.7862 24.2921 18.5681 -1.99613 -8.272 -9.94687 +8015 4 39.0639 24.8191 20.0061 -2.94522 4.87881 -4.09917 +8016 6 12.9717 18.2893 10.6182 7.92512 -8.05782 -7.58833 +8017 4 12.0999 18.3162 10.2013 -2.76008 2.25331 1.21984 +8018 4 12.8722 18.6085 11.5165 -3.68712 5.29275 10.5515 +8019 6 38.0382 41.2423 21.0873 4.88219 -19.6272 -0.152698 +8020 4 37.2014 40.7765 21.2484 2.63704 8.02432 -2.02816 +8021 4 37.8835 0.198079 20.7163 -11.2369 15.8096 -5.69312 +8022 6 6.98214 22.8682 17.8394 -5.75247 -17.9204 -1.57462 +8023 4 7.61723 23.542 17.6412 15.6839 20.0065 -5.16874 +8024 4 7.3587 22.0484 17.4826 -2.13646 0.815835 3.23256 +8025 6 24.1186 19.368 12.3177 21.0449 6.23804 -24.2445 +8026 4 23.9242 19.844 13.1293 -4.19124 -3.15082 3.8784 +8027 4 23.743 18.4928 12.3308 -10.9397 -14.908 7.07664 +8028 6 44.2213 28.4415 4.8153 2.12167 -7.44997 -5.8313 +8029 4 44.3009 28.0649 3.91739 -1.37383 9.18016 5.99771 +8030 4 44.2294 29.4128 4.74855 1.01191 -3.53144 -7.03239 +8031 6 23.3167 8.29314 21.4338 -0.329791 14.7993 14.6131 +8032 4 22.995 9.23581 21.5362 7.25813 -26.2111 -7.67418 +8033 4 23.1349 8.01865 20.5229 -2.36131 4.58949 1.23489 +8034 6 14.3464 2.19127 18.5365 1.00479 -5.05512 -1.33996 +8035 4 14.3534 1.26337 18.7781 -10.0191 -8.45544 9.17935 +8036 4 15.2531 2.29149 18.2562 13.6881 11.5937 -7.27189 +8037 6 28.0536 31.92 34.134 3.57463 -14.0429 -1.6048 +8038 4 28.4517 32.4188 34.8607 -2.66641 5.35559 -0.0232853 +8039 4 27.3246 32.4577 33.7701 8.655 -3.68096 2.2403 +8040 6 53.3502 24.7032 18.2649 -24.2711 -41.2818 -9.83264 +8041 4 53.5194 24.6019 17.3193 6.96991 8.47211 -0.102973 +8042 4 53.68 25.5059 18.6169 17.7955 37.5084 3.34479 +8043 6 36.8031 28.4187 22.9511 -10.1554 -0.61119 21.2214 +8044 4 36.5106 28.9054 23.7358 4.15696 8.73481 -5.19311 +8045 4 36.1845 27.6911 23.0035 -2.36033 -17.8474 -9.79811 +8046 6 21.8885 30.5877 27.4793 -3.11585 8.28062 7.57241 +8047 4 22.2621 31.0993 28.2061 -3.96796 1.5816 4.48491 +8048 4 22.5937 30.5949 26.8475 10.2249 -8.24374 -18.6607 +8049 6 10.2833 3.28406 27.2289 -24.5304 -2.91212 14.6365 +8050 4 10.0443 2.76427 28.0065 14.6588 -5.9106 -2.57837 +8051 4 9.44832 3.75002 27.1066 2.80489 10.142 -13.305 +8052 6 37.7147 24.9939 29.6988 5.24245 -12.5023 -10.1121 +8053 4 38.3581 24.5533 29.0689 -23.3017 1.4918 23.5498 +8054 4 37.1779 24.3214 30.1874 12.7329 5.56421 -12.5271 +8055 6 9.13611 24.4367 14.4784 20.7258 8.96054 28.4908 +8056 4 9.04651 24.998 13.735 -5.03994 20.1658 -22.0876 +8057 4 8.726 23.6299 14.2398 -14.2121 -32.2206 -7.12291 +8058 6 52.7755 31.4643 7.39569 14.5412 -1.52098 0.484013 +8059 4 52.3413 32.1584 6.88884 0.00633314 4.2069 -4.47258 +8060 4 52.0605 30.9716 7.79316 -9.34275 -9.05133 5.36325 +8061 6 21.3287 5.44475 36.4975 17.176 -11.9485 -14.2877 +8062 4 20.7483 5.50715 37.2619 4.90115 -8.53405 7.77147 +8063 4 21.912 4.64524 36.5597 -18.1029 20.6035 4.94996 +8064 6 25.1768 37.2214 4.32574 4.31983 -25.8241 -7.35849 +8065 4 25.4326 36.64 3.57657 -1.88178 18.0132 5.09494 +8066 4 24.8685 36.5657 4.9694 -1.32139 10.7309 7.78615 +8067 6 33.9928 17.4475 18.2473 -28.4515 -0.0793518 28.5349 +8068 4 34.2921 17.0113 19.1053 -15.0281 13.9289 -20.2703 +8069 4 33.1064 17.9171 18.4165 33.1367 -21.5966 1.81969 +8070 6 37.9532 37.4932 25.2939 -37.7872 -15.4269 -20.4394 +8071 4 36.979 37.7096 25.1406 34.3292 -3.43428 9.43604 +8072 4 38.1084 36.7677 24.6487 1.47089 11.2608 10.0337 +8073 6 5.08061 4.87523 15.8431 -4.86231 -7.56388 -2.23136 +8074 4 5.78156 4.1744 15.8759 -9.54967 26.0091 2.46095 +8075 4 5.43258 5.75 16.0822 6.78608 -13.538 3.56789 +8076 6 14.1628 7.20449 7.78038 25.2379 -5.46067 -13.6381 +8077 4 13.5115 7.54153 8.36471 -22.6877 11.2017 23.85 +8078 4 13.6914 6.99143 6.96374 5.13235 0.836748 0.117842 +8079 6 24.9714 10.8522 38.0874 21.7543 24.8019 24.8971 +8080 4 25.3733 11.7327 37.9223 -2.75098 -14.513 10.3213 +8081 4 24.5811 10.6456 37.27 -22.0988 -18.3607 -37.1034 +8082 6 35.6792 7.98105 22.8098 -5.63995 -0.874411 -1.68631 +8083 4 36.3111 8.66137 23.0699 5.30437 2.23481 0.770305 +8084 4 35.3824 8.20038 21.9134 0.62108 2.61089 2.3422 +8085 6 24.7967 29.145 22.4166 8.97915 1.26062 2.6062 +8086 4 24.9285 28.4017 23.0307 -7.24415 3.31799 -2.87627 +8087 4 23.8684 29.1691 22.1667 -6.93063 -5.53381 0.128782 +8088 6 38.5003 31.6402 38.4666 0.118802 17.9484 -3.06973 +8089 4 38.5639 32.3894 37.8454 -0.598215 -11.959 -0.514206 +8090 4 38.3632 32.08 39.3134 -2.43734 -3.45212 12.1107 +8091 6 7.2246 33.2558 15.4144 3.93224 14.6297 14.7993 +8092 4 8.10558 33.3578 15.8508 -19.4169 -6.69939 -13.0108 +8093 4 7.30076 32.5035 14.7978 2.24681 10.3389 8.67702 +8094 6 43.3411 23.605 1.45378 1.24542 -6.52262 6.11498 +8095 4 43.1714 24.3501 0.858367 5.1295 -5.17404 3.37123 +8096 4 44.2208 23.7695 1.84296 -12.8059 2.13297 -8.4534 +8097 6 3.53981 32.9157 14.8686 -7.67856 -8.73615 6.98201 +8098 4 3.60397 33.2061 13.9566 0.668747 6.43783 -7.96574 +8099 4 3.81902 33.649 15.4236 5.03764 7.23473 -0.501009 +8100 6 25.308 21.7722 8.24708 3.37146 -12.406 14.7751 +8101 4 26.0573 21.1741 8.36562 1.41198 8.84323 -6.65363 +8102 4 24.826 21.6647 9.09095 -1.64121 7.89428 -12.8382 +8103 6 43.814 15.3562 17.763 -19.8802 -3.64728 -7.58039 +8104 4 43.4756 15.1225 16.8733 5.20247 0.973102 4.81929 +8105 4 44.7686 15.2775 17.7045 7.07231 -2.77487 -5.74422 +8106 6 15.7867 16.2594 16.6597 40.7179 11.0003 30.8626 +8107 4 16.4245 16.8568 16.2414 -0.344326 0.180624 1.74019 +8108 4 15.1074 16.2177 16.037 -41.8412 -2.72902 -33.087 +8109 6 31.9018 12.864 11.5221 -0.527288 11.9796 -2.61342 +8110 4 32.4715 13.19 12.2739 -15.261 0.218931 -18.2329 +8111 4 31.4408 13.5947 11.0331 13.5047 -10.6099 18.0399 +8112 6 18.2179 5.3463 10.1762 9.71532 5.2148 -18.3501 +8113 4 17.8204 5.66693 9.33813 -2.6575 -7.74782 15.1878 +8114 4 17.5556 5.18411 10.851 -9.29453 0.73034 -3.17809 +8115 6 23.0812 39.0781 10.9303 2.37609 8.25457 -4.90642 +8116 4 24.0025 38.8104 10.892 -1.10831 -0.594451 2.83356 +8117 4 23.078 39.9337 10.4697 -7.78026 -4.85412 5.47405 +8118 6 46.8678 33.747 8.76655 -5.11485 44.7451 24.4631 +8119 4 46.406 34.5339 8.40734 -0.304999 -21.98 -10.152 +8120 4 47.1603 34.1422 9.62028 2.09293 -20.2864 -11.5212 +8121 6 31.2447 39.9321 20.2226 -0.330123 -0.585472 -4.98228 +8122 4 30.8504 39.3151 19.5884 6.05804 4.05585 3.92388 +8123 4 32.2053 39.9316 20.0453 -4.95864 -1.44581 -1.12159 +8124 6 15.9016 33.0949 19.7876 25.1907 -5.52815 -22.1207 +8125 4 16.0748 33.7133 19.0349 -1.92202 -14.988 11.1016 +8126 4 16.5267 32.3265 19.6592 -15.8695 19.8556 5.2806 +8127 6 32.5654 39.9188 2.66304 17.6014 -10.2623 -15.3377 +8128 4 33.3417 39.59 3.14903 -11.9816 5.68487 0.865723 +8129 4 31.9971 40.348 3.29791 -5.42947 4.08066 9.69521 +8130 6 50.71 12.2088 3.91621 6.45352 -28.1924 -19.9843 +8131 4 51.4315 12.4725 3.33505 0.00989865 5.72461 1.55844 +8132 4 50.5782 12.8645 4.57223 -0.528152 29.464 22.8196 +8133 6 44.6954 2.75762 12.1022 0.941183 0.541095 5.21442 +8134 4 45.0772 1.91827 11.8337 7.97486 -4.13832 -5.1586 +8135 4 44.7961 2.76556 13.0748 -3.12194 1.26681 -13.8655 +8136 6 11.5119 11.9446 31.6555 0.0165034 5.87533 16.9496 +8137 4 11.2786 12.7291 32.193 1.1093 -4.42098 -1.85793 +8138 4 11.5615 11.2089 32.2952 3.49417 6.36211 -10.0029 +8139 6 4.75553 10.0442 10.5026 -0.613356 7.28818 -1.41717 +8140 4 5.04922 10.2458 11.3982 -0.190174 3.033 -2.19553 +8141 4 4.45357 10.8768 10.0827 4.22944 -8.29703 6.91569 +8142 6 17.1004 25.0221 20.585 20.8628 27.7333 -27.8469 +8143 4 16.2314 24.7196 20.7848 -24.892 -11.5638 6.73224 +8144 4 16.9745 25.5771 19.7683 4.93088 -15.3222 19.1034 +8145 6 48.1032 4.75801 14.8026 37.7024 -16.8658 7.41777 +8146 4 47.1817 4.923 14.9438 -21.3904 13.2232 -6.86149 +8147 4 48.4894 5.33532 14.1187 -17.354 1.23192 4.40994 +8148 6 18.8584 3.1094 3.41532 -17.9645 -5.092 -5.76247 +8149 4 18.4858 2.24853 3.65522 2.22195 0.198645 3.24183 +8150 4 19.7914 2.99202 3.55078 21.8001 -2.9136 1.99579 +8151 6 35.4214 26.4496 29.0479 -25.0869 -13.2406 8.30382 +8152 4 35.4596 27.2122 28.4766 3.66886 10.9927 -9.48044 +8153 4 36.2884 26.0622 29.0901 17.6032 -4.12101 -3.28535 +8154 6 32.3918 31.2203 12.8386 46.3164 14.9485 -1.56764 +8155 4 31.5927 31.2548 13.3118 -34.7781 -0.694705 18.2501 +8156 4 32.2274 30.836 11.9945 -8.46486 -12.2685 -25.2096 +8157 6 32.9972 28.3347 37.5978 -19.2694 -14.478 20.0019 +8158 4 32.1604 27.8545 37.87 25.9433 12.8245 -4.2723 +8159 4 33.4478 28.5699 38.4425 -10.0504 -3.89776 -17.7975 +8160 6 45.4943 24.785 10.3174 -24.9891 51.3938 13.5053 +8161 4 44.9436 25.3819 9.72852 18.6998 -28.2383 15.0369 +8162 4 45.6946 23.9769 9.88803 3.95472 -26.3164 -24.236 +8163 6 14.7646 31.7016 3.17106 -12.494 -4.77828 16.8956 +8164 4 14.1278 32.382 2.84257 8.55448 -13.727 9.9815 +8165 4 14.4774 31.2925 4.03575 0.781246 20.1514 -26.73 +8166 6 31.932 7.70259 4.29822 28.2629 -13.9597 32.9447 +8167 4 31.5142 6.8338 4.23667 -1.26054 0.464616 -4.26218 +8168 4 31.5893 8.26695 3.64018 -18.9284 22.0156 -31.588 +8169 6 42.5661 17.3076 32.2072 4.58091 20.9841 -12.8778 +8170 4 41.6153 17.2751 32.1225 -13.9289 -9.63208 0.974916 +8171 4 42.7549 18.1312 31.7017 7.23855 -15.1499 9.29454 +8172 6 13.801 23.1802 23.5544 20.5107 -9.18639 9.43365 +8173 4 13.5559 23.799 24.2431 -7.02941 8.57916 4.58982 +8174 4 14.6139 22.757 23.9348 -15.8084 7.21572 -12.2969 +8175 6 10.7224 7.09218 3.96878 16.2046 -14.1912 -58.7694 +8176 4 10.4615 7.01435 4.86228 -13.7845 -9.22242 34.898 +8177 4 10.4899 6.25858 3.45399 4.94204 24.1379 24.5516 +8178 6 28.7975 8.66057 17.8838 -26.4281 5.00156 -27.4828 +8179 4 29.5466 8.31163 17.3909 5.91048 -3.96826 -5.96201 +8180 4 28.1517 8.96764 17.1731 20.0585 -9.38402 22.2692 +8181 6 19.4445 29.3512 26.6402 -27.7559 12.8002 37.2849 +8182 4 18.9931 29.7086 27.4672 16.1765 -10.1498 -30.4371 +8183 4 20.3292 29.7071 26.6996 8.86807 3.45557 2.67965 +8184 6 40.676 40.9989 14.5783 -1.81287 -10.2023 17.4849 +8185 4 40.8703 41.6798 13.9303 10.8761 5.87921 -5.34291 +8186 4 41.4788 40.6754 15.0317 -0.103076 9.61372 -9.63617 +8187 6 46.2568 14.0853 31.7234 10.6503 -1.46249 4.93376 +8188 4 46.4506 13.1375 31.7184 -3.79774 3.42444 -0.601084 +8189 4 45.5065 14.2191 31.1522 -8.96365 0.976246 -7.34606 +8190 6 36.7103 36.3065 8.39844 -19.1971 -27.2559 -17.1971 +8191 4 36.3822 37.2167 8.51449 20.2374 -9.10083 14.9839 +8192 4 37.462 36.0245 8.9597 -8.83948 23.9771 2.75809 +8193 6 30.7983 32.4219 38.0908 -28.9564 1.76229 18.7871 +8194 4 31.3387 31.9445 37.476 23.2205 -2.83162 -11.1976 +8195 4 31.2894 33.1287 38.5298 9.85106 -3.61838 -6.87003 +8196 6 47.9 8.84746 10.1809 13.9026 13.2481 4.99334 +8197 4 47.2314 9.07534 9.54683 -14.9306 19.0332 -8.73943 +8198 4 48.008 7.93273 10.003 10.2061 -26.7512 4.08493 +8199 6 24.4282 17.0027 30.9766 -8.14946 0.47403 -13.61 +8200 4 23.7021 16.9118 30.3187 14.132 0.581257 9.28124 +8201 4 24.0019 17.1514 31.8341 1.66288 -1.35228 -5.87998 +8202 6 40.5039 5.09263 4.48513 -8.56504 -6.5373 -32.2613 +8203 4 41.2755 5.64065 4.37578 16.2932 9.35997 9.97847 +8204 4 40.1843 5.0523 3.55179 -2.89742 -7.45623 19.6864 +8205 6 52.5794 28.086 6.91602 -27.2154 -20.1235 6.97783 +8206 4 52.4353 28.6007 6.11552 3.94928 -0.112987 0.705634 +8207 4 51.6969 27.6552 7.08025 27.1089 14.7333 -4.60736 +8208 6 36.0629 32.381 23.6142 9.17579 -16.9148 -2.4755 +8209 4 36.5407 32.2813 22.7776 -1.15674 3.38979 7.41153 +8210 4 35.7113 33.2654 23.6252 -9.15386 11.2493 0.0331211 +8211 6 23.6552 31.8756 22.7565 -25.0136 1.00336 21.6204 +8212 4 23.73 32.5959 22.1297 15.1034 -2.64982 -11.1407 +8213 4 24.3343 31.2055 22.6866 12.2933 -0.39941 -10.0267 +8214 6 0.736598 24.4641 41.7072 -6.94393 1.55048 -19.4095 +8215 4 1.23654 24.8288 40.9522 -3.95743 -2.80997 9.51773 +8216 4 54.8325 24.2702 41.3637 13.4109 4.08216 3.5339 +8217 6 15.9721 8.97822 19.8125 19.0517 -22.613 16.6544 +8218 4 15.5497 8.29105 19.3091 -4.28185 -9.24838 -10.3339 +8219 4 15.6128 9.78815 19.5092 -16.7051 35.4763 -13.493 +8220 6 33.1656 12.5735 20.0353 32.8597 -32.3881 -24.7893 +8221 4 32.9817 11.6196 19.8453 -6.04217 28.6875 8.28399 +8222 4 34.1172 12.6638 19.7368 -32.1809 10.6792 11.3696 +8223 6 7.04894 24.9401 26.3957 -12.3425 -2.00741 -5.21086 +8224 4 6.75821 24.2907 27.0478 8.01299 -1.99342 6.24335 +8225 4 7.89161 25.3154 26.6505 10.7219 -3.29246 12.7441 +8226 6 44.479 22.5508 36.9163 -6.8399 -5.44184 13.3083 +8227 4 43.5214 22.4098 37.071 12.5044 3.3732 -3.51472 +8228 4 44.595 22.7899 36.0028 -4.86816 3.42784 -13.6235 +8229 6 39.2745 23.7032 25.1197 -32.3737 -81.7274 9.17932 +8230 4 39.5886 24.5492 24.9992 24.471 68.8814 -13.2187 +8231 4 38.7456 23.4691 24.3377 5.22396 6.33701 6.85867 +8232 6 20.3646 2.19602 36.9892 -4.85825 6.83938 3.69158 +8233 4 20.3067 1.45038 37.5971 1.4243 -8.23943 -2.36696 +8234 4 20.3942 1.88275 36.0861 3.42557 -6.35335 -2.19064 +8235 6 22.8664 19.5513 3.67104 -13.2265 5.28042 31.2857 +8236 4 22.7633 19.8561 4.6286 7.01101 -9.22167 -32.7463 +8237 4 23.7764 19.7315 3.39612 4.00916 2.85623 5.02623 +8238 6 31.705 12.5768 34.6039 18.8969 7.7197 42.0834 +8239 4 31.1026 13.3107 34.9476 21.2302 -23.3848 -5.30166 +8240 4 32.3569 12.3026 35.3493 -33.8624 17.1964 -33.567 +8241 6 12.9851 10.2105 25.0956 -25.1193 26.0078 -38.429 +8242 4 13.6149 10.0452 25.7619 22.39 -15.9831 32.7066 +8243 4 12.4963 9.40655 24.9468 1.34194 -14.9569 1.62555 +8244 6 27.2621 0.584423 13.2176 -28.6404 -16.2485 2.71576 +8245 4 27.7069 41.6292 13.1518 2.13728 8.59646 -2.51953 +8246 4 26.2847 0.395264 13.1771 23.0038 6.72582 -0.601928 +8247 6 5.66006 24.9398 13.9833 -7.43295 9.91556 10.5591 +8248 4 4.70147 24.9177 13.9802 -4.26929 -7.73667 -8.07402 +8249 4 5.82197 25.381 14.8221 8.41297 -1.15026 -0.763214 +8250 6 22.9908 17.9523 0.521723 7.02411 -25.4698 12.909 +8251 4 22.4592 18.6506 0.142784 -9.22706 3.46645 -2.83539 +8252 4 22.3527 17.3052 0.930771 13.2695 22.3169 -13.3733 +8253 6 33.0935 25.4243 5.46557 -9.38497 -10.8046 -8.60877 +8254 4 33.4966 26.2756 5.44764 14.9521 17.8538 5.01915 +8255 4 32.9941 25.2035 4.5344 -2.6207 -6.96629 2.5324 +8256 6 8.53079 7.95552 17.4804 7.64086 6.41223 -26.4035 +8257 4 9.4001 8.35547 17.2638 -9.73917 -4.33322 7.64386 +8258 4 8.4487 7.94255 18.4286 4.30191 2.70426 16.6029 +8259 6 26.8371 0.685906 2.89773 -0.256761 31.01 4.86999 +8260 4 26.7806 0.433187 3.83156 0.637082 -2.67537 2.60738 +8261 4 26.6279 1.66343 2.89109 6.9325 -26.481 -2.08778 +8262 6 50.0417 34.7142 15.6334 -23.0288 8.72534 -30.9996 +8263 4 50.5531 35.2159 14.9759 6.02412 -4.51102 12.1494 +8264 4 49.1615 34.6714 15.1751 14.0914 -5.62478 19.352 +8265 6 46.2791 4.99946 11.1196 9.7179 12.4772 -7.72995 +8266 4 45.7827 4.25534 11.4529 -10.6417 -11.5364 6.26713 +8267 4 46.9456 4.6214 10.5389 1.00953 -4.68959 -1.2994 +8268 6 33.7936 38.6123 35.3918 15.2762 25.882 47.4359 +8269 4 34.0305 39.0866 36.2411 -6.18084 -28.1229 -24.2145 +8270 4 33.6134 39.3784 34.8506 -5.42867 -1.33428 -20.4371 +8271 6 30.8282 25.8371 41.2172 -7.09757 -19.9215 -22.3179 +8272 4 31.1427 24.9253 41.375 1.19635 8.28989 4.89631 +8273 4 31.1138 26.3841 0.0263053 10.2845 10.2166 22.0109 +8274 6 50.2275 0.982033 24.4751 51.8832 -7.79127 14.7425 +8275 4 49.5671 0.561213 23.9746 -37.5145 -10.5742 -20.1648 +8276 4 51.0349 0.46072 24.2534 -17.6876 18.8276 11.0022 +8277 6 31.2908 0.710797 19.047 -2.09434 13.573 -1.22083 +8278 4 30.4487 0.672221 18.611 -14.5784 9.11804 -11.7691 +8279 4 31.2841 41.7946 19.4765 8.98672 -35.4229 20.9418 +8280 6 39.0741 29.5515 19.1276 -25.3595 -21.9961 15.137 +8281 4 38.1807 29.4949 19.565 25.109 7.94863 -12.7917 +8282 4 39.4837 28.6866 19.3452 2.49072 15.8212 -6.56848 +8283 6 21.6546 17.5955 25.8962 -6.78298 15.7545 0.118362 +8284 4 22.0482 18.4938 26.0891 -15.3421 -24.4294 -5.96834 +8285 4 20.8112 17.7106 25.4012 18.8301 2.25602 6.45745 +8286 6 35.0761 28.7988 27.4227 3.11164 -5.22767 30.3338 +8287 4 35.4099 29.4705 28.0422 -1.31539 -7.25274 0.820077 +8288 4 35.176 29.229 26.5925 2.58985 10.308 -31.8228 +8289 6 30.7102 25.4463 11.6589 -5.09223 14.513 32.8165 +8290 4 30.6059 25.8179 12.6014 3.72506 -14.6402 -39.0718 +8291 4 30.6061 26.1982 11.055 2.14208 -0.820709 7.44645 +8292 6 7.34821 15.124 12.3469 -7.98455 -28.7648 8.02815 +8293 4 6.65824 14.4547 12.1585 7.38491 7.52419 4.72727 +8294 4 7.19665 15.7511 11.658 -2.78105 24.4343 -15.0907 +8295 6 16.8417 26.815 7.05419 -24.774 6.28148 -21.5195 +8296 4 17.6138 26.5995 7.5418 30.7131 -10.23 16.3776 +8297 4 17.1302 26.9688 6.14022 -2.93816 -3.28182 4.8763 +8298 6 29.5112 33.0571 30.9901 -17.2684 21.8413 -16.809 +8299 4 28.6007 32.8494 30.6893 8.91061 -10.9491 6.08618 +8300 4 29.8939 32.355 31.5124 -6.62171 -19.0922 5.25725 +8301 6 14.1054 2.12143 30.9174 -7.90077 -11.4283 37.211 +8302 4 14.0041 2.00138 31.9209 0.0297695 4.78336 -39.0496 +8303 4 13.7376 1.30679 30.5176 6.48361 9.45743 4.44265 +8304 6 15.6593 22.2688 2.88796 -26.3773 12.8308 -8.6958 +8305 4 16.4059 21.7286 3.01985 35.1738 -16.1657 6.55343 +8306 4 15.0005 21.6175 2.62854 -10.183 2.33344 0.69621 +8307 6 23.7324 29.1178 40.9691 12.375 28.71 1.88761 +8308 4 23.2563 30.0016 40.9795 15.1309 -27.3218 0.73938 +8309 4 24.7153 29.2815 40.9372 -24.8849 -3.40565 0.339466 +8310 6 38.1289 14.1609 13.7163 11.3988 23.3452 4.961 +8311 4 37.6355 13.3641 13.8052 -15.0683 -25.2976 3.04519 +8312 4 38.877 13.9408 13.1592 7.07353 -0.711776 -7.39216 +8313 6 35.2564 26.5047 15.5196 1.21661 4.3606 12.6683 +8314 4 34.5556 26.4436 14.8616 -0.145442 -0.409522 -0.299569 +8315 4 34.9009 27.0522 16.256 4.1263 -8.75979 -17.8666 +8316 6 19.0944 34.7315 16.477 3.93496 0.874554 38.8769 +8317 4 19.5342 35.6013 16.5498 -2.87948 -9.96323 -9.99674 +8318 4 19.0181 34.4301 15.5899 3.71142 3.01681 -30.4069 +8319 6 18.1805 29.7449 35.7046 18.8444 17.1873 -3.97052 +8320 4 18.2235 30.6593 35.335 -4.4784 -20.2666 13.1463 +8321 4 19.056 29.5886 36.1261 -9.76671 1.23141 -6.47371 +8322 6 54.1188 22.2659 24.9096 4.78421 -24.6774 -19.3149 +8323 4 53.6441 21.8104 24.1769 10.121 5.11789 9.9801 +8324 4 53.5075 22.9378 25.1661 -14.3198 20.1313 5.7187 +8325 6 30.3323 10.3375 34.0061 7.35563 0.641124 -2.21855 +8326 4 29.5734 10.4043 34.5817 -14.4555 0.0376959 9.72957 +8327 4 30.8213 11.1653 34.1487 -3.17747 -4.67635 -0.590304 +8328 6 38.3211 33.8974 18.5888 -1.32754 -0.89807 -0.720993 +8329 4 38.9926 33.271 18.8539 2.22312 -19.1913 3.89796 +8330 4 38.8713 34.6655 18.5317 3.84957 24.8056 -1.31283 +8331 6 22.4809 14.1697 34.431 -22.1622 -5.27184 -37.8541 +8332 4 22.5433 13.5186 33.673 0.822047 20.8222 24.5167 +8333 4 23.1773 14.0067 35.0533 16.0768 -5.18569 10.3575 +8334 6 38.0141 0.622036 2.34694 9.03481 -5.1652 10.3599 +8335 4 37.7113 1.09641 3.1189 -18.3016 16.1314 2.00329 +8336 4 38.7028 0.120019 2.79986 6.1006 -11.8827 -16.4842 +8337 6 38.8847 41.1446 10.3004 16.8495 57.0142 -12.497 +8338 4 38.6453 0.212884 10.3117 6.47193 -33.8599 -1.337 +8339 4 38.2374 40.7573 10.8541 -26.8649 -17.5582 22.9746 +8340 6 53.4109 21.9211 38.9712 27.3607 0.0645619 -10.5759 +8341 4 53.0384 21.9801 38.0859 -10.7304 2.2749 -0.0111998 +8342 4 54.3668 22.0571 38.7395 -19.1981 -5.88632 12.9741 +8343 6 39.9872 12.7205 36.288 -8.06793 35.3321 20.4333 +8344 4 39.087 12.3834 36.3725 1.18883 -9.13664 -3.11406 +8345 4 40.4905 12.1818 35.7009 7.36107 -20.124 -19.0601 +8346 6 48.4463 17.2389 40.5967 -24.7278 4.81563 12.4078 +8347 4 47.5665 17.6971 40.4852 25.7833 -12.0744 1.257 +8348 4 48.3987 16.886 41.5134 6.10343 4.05346 -12.6042 +8349 6 32.0413 9.35688 40.0251 1.84943 -9.41379 10.5137 +8350 4 32.8011 9.3156 39.4233 -4.71533 -3.42986 0.347912 +8351 4 31.8082 8.43016 40.2864 3.98001 20.4877 -6.20043 +8352 6 31.7351 22.4909 6.36481 -11.9835 4.517 5.86255 +8353 4 31.4453 21.6589 6.79738 2.31245 15.2673 -2.59345 +8354 4 31.3521 23.2372 6.88711 4.39127 -22.2776 -7.77946 +8355 6 51.0252 2.58567 21.5888 12.0252 -3.79771 4.1956 +8356 4 51.3852 1.69652 21.8042 -1.91984 13.1306 -1.09782 +8357 4 51.7712 3.19849 21.4753 -6.25067 -9.48202 2.92476 +8358 6 13.6387 22.0486 12.1519 25.289 13.6281 9.24284 +8359 4 14.4553 22.4795 12.4841 -9.12946 -7.35477 -7.44936 +8360 4 12.9422 22.6971 12.3091 -5.69931 -0.254566 -0.690626 +8361 6 23.6098 24.0343 14.6404 -2.85842 21.3712 -30.1324 +8362 4 24.3054 24.4792 15.1401 1.72137 -5.65962 3.08819 +8363 4 23.5196 24.6041 13.8393 -4.42688 -17.9982 21.1692 +8364 6 9.32217 4.85318 31.2328 11.4746 -4.61869 -4.10735 +8365 4 8.43042 4.86168 30.8848 -9.06213 4.49291 -0.279243 +8366 4 9.25495 5.26013 32.106 -3.85952 -1.36 2.0258 +8367 6 16.6786 26.3118 18.041 -30.5179 5.83101 -14.1852 +8368 4 15.8205 26.6594 17.6987 9.23568 -14.6779 7.38956 +8369 4 17.2149 27.0871 17.9121 20.6972 11.6613 1.32787 +8370 6 5.1068 13.5155 11.5503 -9.62018 18.629 -29.2057 +8371 4 4.37741 13.3629 12.1623 -7.62379 -0.222526 0.540006 +8372 4 4.70689 13.979 10.7366 10.5209 -18.4088 37.9064 +8373 6 29.6181 23.6359 8.06142 -1.81854 7.21422 -1.70755 +8374 4 29.1888 23.4521 8.90141 0.206013 -3.23773 -0.0922606 +8375 4 29.4815 24.5976 7.98987 7.61073 -10.2969 -5.72522 +8376 6 0.801466 7.54671 27.8401 6.5354 -3.49578 -14.7683 +8377 4 0.895859 7.27352 28.7573 1.78004 -0.979843 7.25552 +8378 4 1.54585 8.15528 27.6648 -11.1939 -10.5496 5.25649 +8379 6 15.4336 9.77253 0.489553 0.922542 4.3707 -1.35473 +8380 4 16.0351 9.34865 41.7726 4.14277 -6.55565 2.56274 +8381 4 15.4857 9.31476 1.34042 4.74784 -1.15717 -0.337147 +8382 6 18.8008 0.0730809 34.105 -10.3773 -6.96418 -21.8764 +8383 4 18.5081 41.5423 33.2731 5.22569 12.9238 15.5106 +8384 4 18.5071 0.998566 34.0742 -2.68781 1.40869 -5.2752 +8385 6 18.7326 30.7673 29.1559 48.9948 -22.8293 28.8452 +8386 4 19.5421 30.7479 29.7792 -35.6741 -9.01286 -31.0748 +8387 4 18.496 31.6741 29.187 -17.0068 24.787 -0.45657 +8388 6 48.459 16.4997 36.139 1.45519 10.5028 1.01521 +8389 4 47.6111 16.9857 36.2164 10.4415 -5.87096 -2.55811 +8390 4 48.4968 16.1176 35.2432 -2.18798 4.21486 5.30298 +8391 6 43.8007 0.467658 29.2569 28.3678 -13.8677 -3.77703 +8392 4 42.8971 0.305725 29.4937 -25.3214 -1.14832 5.94808 +8393 4 44.2622 41.5592 29.5347 -3.4854 12.8866 -0.12306 +8394 6 16.7282 13.8764 21.3804 -5.85841 5.25102 8.86173 +8395 4 16.2274 14.7005 21.5266 6.94274 -6.60805 -7.01164 +8396 4 16.607 13.4327 22.2267 1.29648 -4.09529 1.45702 +8397 6 17.3848 13.434 26.2514 27.8708 0.579352 -19.8612 +8398 4 18.2073 13.6243 25.7048 -28.5107 -7.2193 21.7409 +8399 4 17.5944 12.6077 26.718 -2.1357 3.12496 0.608863 +8400 6 48.1647 10.2208 23.7049 7.80266 -18.7522 13.388 +8401 4 47.9825 10.5204 24.6118 -3.05612 1.76991 -8.97221 +8402 4 48.0139 10.9468 23.1026 -1.19683 7.34816 1.26356 +8403 6 28.2773 17.9142 17.8758 3.72989 18.9709 -15.182 +8404 4 29.0682 18.432 17.6259 -4.1904 -8.84834 4.2635 +8405 4 28.5441 17.0749 18.25 8.7895 -11.8779 5.35139 +8406 6 54.0848 38.1774 23.6862 8.79068 2.20397 4.23058 +8407 4 0.0366427 38.003 23.4974 -14.1536 0.885634 -1.20583 +8408 4 53.5245 37.5494 23.203 6.54807 -0.952262 -0.611804 +8409 6 8.48984 18.3998 11.4055 -13.462 -3.57414 27.789 +8410 4 7.65602 18.6961 11.043 -9.38292 3.75479 -0.915161 +8411 4 9.09748 18.5243 10.712 30.3826 3.02886 -30.4498 +8412 6 45.9441 12.8818 11.0222 -16.4049 1.91652 -6.40765 +8413 4 46.711 12.6299 10.4835 -7.54952 -0.564906 -6.57768 +8414 4 45.1235 12.7466 10.4771 21.7466 0.735613 7.10643 +8415 6 16.2215 8.79448 14.033 27.9098 -14.9816 6.01142 +8416 4 15.5522 9.3752 13.7952 -53.829 20.9905 -11.5495 +8417 4 16.9359 9.40542 13.9326 31.9466 3.3348 3.59486 +8418 6 42.7223 13.3863 21.3918 29.8224 16.7773 6.64199 +8419 4 41.9142 12.8874 21.2836 -9.67718 -3.29752 -8.9243 +8420 4 42.6271 14.312 21.0975 -16.0363 -11.184 0.152454 +8421 6 20.9977 40.4228 16.4707 19.2311 -21.9074 5.84064 +8422 4 20.7341 40.0536 17.3362 -0.495629 5.04161 -8.05599 +8423 4 21.8212 39.937 16.2081 -24.2166 11.8961 5.45251 +8424 6 45.6397 11.4296 32.9439 38.4109 -29.1814 -9.99274 +8425 4 46.3321 10.7493 33.2028 -28.4056 24.9384 -5.22126 +8426 4 45.113 11.6624 33.7013 -7.79747 1.97566 18.4384 +8427 6 26.9602 8.8599 24.2968 13.5915 2.79356 4.8338 +8428 4 27.3951 9.75608 24.2837 -6.20264 -27.5971 5.81865 +8429 4 27.4821 8.2415 24.8764 -5.62896 20.549 -11.158 +8430 6 18.9707 2.44141 29.3655 -2.01209 17.0873 0.653095 +8431 4 18.2519 2.38593 30.0124 -1.45633 -1.83702 1.76482 +8432 4 19.0982 3.39915 29.1871 -0.208097 -9.69202 4.76181 +8433 6 8.2396 29.1642 19.724 -7.67611 -9.48635 17.3168 +8434 4 8.16332 28.9052 20.6672 2.00381 4.74558 -18.2193 +8435 4 7.79264 28.4685 19.2154 1.97612 2.42161 3.19163 +8436 6 9.03293 34.3085 18.6392 -6.8245 -3.51508 -5.57673 +8437 4 8.73043 34.3576 19.5508 2.61936 3.47829 -5.40237 +8438 4 9.19173 35.2194 18.3614 3.83285 -0.179546 -0.301582 +8439 6 10.1806 11.9309 11.2378 5.33181 -8.21116 5.18339 +8440 4 10.4199 12.8404 10.9987 -8.38943 -3.43734 -3.26379 +8441 4 9.2213 11.8063 11.1618 4.16708 15.3888 -2.40164 +8442 6 35.7388 21.6853 36.1571 -21.2187 21.2566 3.59668 +8443 4 35.0074 22.3505 36.1843 15.9506 -16.0405 0.715421 +8444 4 36.3839 21.978 36.8321 -7.05156 -5.2756 -8.86951 +8445 6 17.0774 12.5078 36.39 -5.14261 15.8003 12.7424 +8446 4 17.3404 12.7479 37.2961 -4.35419 -1.09545 -7.6232 +8447 4 17.4977 11.6659 36.234 4.71638 -15.3379 -7.50181 +8448 6 37.1607 13.034 34.2837 0.889917 6.85814 -56.1323 +8449 4 36.6144 12.2451 34.135 3.16712 2.80772 8.73621 +8450 4 37.2953 13.1592 35.1962 -1.91867 -3.10361 40.6259 +8451 6 38.9747 29.5563 13.2253 1.18838 24.1885 -12.4362 +8452 4 38.8174 28.6959 12.8484 -2.87796 -16.626 0.178868 +8453 4 38.7606 29.548 14.1582 -0.666122 -3.30753 9.89159 +8454 6 0.17037 29.343 29.4884 -1.26324 3.91124 -27.2421 +8455 4 0.785297 28.6867 29.1327 1.78511 -2.78426 6.40223 +8456 4 54.9717 29.8735 28.6813 -2.47422 -4.8209 18.3172 +8457 6 15.9286 0.264913 12.7638 2.77369 8.97324 -0.606717 +8458 4 15.3998 0.564835 11.9867 -4.35739 -9.72902 15.1241 +8459 4 15.3918 41.7399 13.4663 -4.26125 7.58409 -15.055 +8460 6 3.98508 11.9472 8.79546 -10.0423 -23.9471 10.8905 +8461 4 4.30821 11.7435 7.92681 6.40121 -7.70989 -16.6116 +8462 4 3.96465 12.8834 8.77069 -2.75643 37.1798 9.03734 +8463 6 24.0517 23.6768 19.9772 9.9875 -0.396554 0.578582 +8464 4 23.5025 22.9354 19.7663 -8.47693 -16.0962 -5.40355 +8465 4 23.4442 24.2751 20.4024 2.14545 13.6845 6.88162 +8466 6 4.48152 2.30986 23.9923 -27.0109 23.4084 27.373 +8467 4 4.59263 2.40669 23.0716 9.73085 -3.6317 -36.525 +8468 4 3.6479 2.81506 24.1139 10.3345 -10.6947 10.8816 +8469 6 33.0856 27.6588 33.8383 -8.68317 -6.77689 0.893276 +8470 4 33.3543 28.5605 33.6822 -2.66039 14.7626 -6.22211 +8471 4 33.7694 27.2718 34.3804 4.93538 -5.90298 8.33006 +8472 6 11.4012 21.7076 6.08442 -20.9181 -7.28975 6.20623 +8473 4 12.3452 21.6439 6.06884 23.6791 -0.506282 -5.12853 +8474 4 11.1369 22.1078 5.25059 3.06155 -0.534748 -3.52863 +8475 6 37.2275 13.5312 23.6107 -13.7454 14.8127 9.96245 +8476 4 37.2011 14.0176 24.4689 -4.04457 -8.03454 -15.7104 +8477 4 38.0738 13.1109 23.5305 19.2281 -7.80113 -1.86698 +8478 6 5.00929 21.0475 33.3676 1.03993 27.0325 -33.9401 +8479 4 4.24931 21.2691 32.771 13.0002 -8.94008 10.7478 +8480 4 4.70945 20.492 34.0664 -10.4226 -16.4153 18.9759 +8481 6 18.2024 37.5737 26.9347 11.0126 -1.54132 -8.69207 +8482 4 17.8515 38.4557 27.1129 2.92195 -1.85995 -3.39903 +8483 4 18.9058 37.6892 26.2602 -8.80934 -3.84756 9.96821 +8484 6 19.7475 16.1502 4.67922 -0.59461 -5.69737 6.80756 +8485 4 18.938 15.9829 5.17999 -0.503733 6.42822 -3.53139 +8486 4 20.452 15.899 5.29485 1.51569 2.54074 -3.7554 +8487 6 54.0588 32.502 15.5791 2.11509 -30.3723 -27.0265 +8488 4 54.9193 32.2734 15.944 -2.03587 2.87368 2.60187 +8489 4 53.7148 33.1889 16.1175 -9.21817 24.1266 16.9863 +8490 6 31.1319 3.81908 36.7331 -8.52453 -12.3767 5.98224 +8491 4 31.0251 4.01663 37.6709 2.24281 6.85123 1.97341 +8492 4 30.7371 2.93942 36.6325 4.48759 4.53933 -4.77061 +8493 6 11.8397 14.3559 5.95013 17.712 13.5011 32.6048 +8494 4 11.8882 13.4483 5.64785 3.21485 -4.29204 1.16864 +8495 4 12.4103 14.428 6.79608 -23.3682 -9.2254 -38.5841 +8496 6 30.4732 33.6903 6.46877 -20.5926 30.9984 10.0988 +8497 4 30.0823 33.146 7.15741 -0.571027 -8.82817 5.88036 +8498 4 31.0368 33.1406 5.95739 18.3645 -25.6031 -16.3825 +8499 6 12.7874 0.539502 21.6719 -8.5062 -5.44338 -19.1545 +8500 4 12.0427 0.939271 21.1459 16.6961 -1.79193 22.1421 +8501 4 12.8959 0.982969 22.5241 -5.23507 7.86641 1.50036 +8502 6 52.7588 7.2218 26.198 16.8025 28.3515 6.33153 +8503 4 53.4065 7.96379 26.3423 -21.978 -17.2249 -4.05545 +8504 4 53.0631 6.80021 25.3976 -2.37526 -6.61619 -6.13258 +8505 6 39.7335 40.8867 3.73325 7.25622 8.93714 -16.4459 +8506 4 39.3445 40.0379 3.8542 -7.03998 -23.1188 -2.87281 +8507 4 39.6833 41.2661 4.59764 3.93702 15.0893 17.324 +8508 6 20.121 31.9222 21.9838 -6.71526 -6.20654 6.86321 +8509 4 19.4522 31.9772 22.708 13.7594 -4.46219 -12.9776 +8510 4 20.3423 32.8279 21.7497 1.41177 8.86705 -0.575134 +8511 6 12.8675 35.0031 4.45346 44.828 -17.7313 4.60062 +8512 4 12.2237 35.6716 4.40701 -39.658 29.9319 -2.18346 +8513 4 13.7076 35.4677 4.24983 -7.53722 -6.26381 -0.0905995 +8514 6 24.0625 33.6591 24.8433 7.47563 8.71661 -6.22666 +8515 4 23.7256 32.9086 24.3593 -5.011 -9.84395 -6.229 +8516 4 24.8651 33.8891 24.3525 -1.08488 0.504411 0.449776 +8517 6 40.1566 40.8925 22.745 3.65995 -18.1772 23.084 +8518 4 39.459 41.1173 22.1514 -10.4135 8.7075 -19.9273 +8519 4 39.655 40.5713 23.5068 11.7186 -0.819555 2.88668 +8520 6 15.5608 2.83174 38.4548 -17.961 4.93292 18.3513 +8521 4 14.8017 3.44348 38.6509 23.1729 -8.01231 -13.692 +8522 4 16.317 3.27039 38.0376 1.48109 9.53369 -0.90723 +8523 6 41.0116 9.17543 16.9495 15.4695 -4.08523 -13.4682 +8524 4 41.9148 8.77619 16.8957 -14.8555 5.86712 4.74383 +8525 4 40.5932 8.80873 17.73 -3.00249 -3.47282 8.63794 +8526 6 43.1871 41.3934 9.57744 -8.69666 -18.4537 3.1119 +8527 4 42.3844 40.9156 9.26306 10.8189 9.37287 1.53096 +8528 4 43.2581 0.273962 9.04681 -5.03874 9.79533 -5.6553 +8529 6 24.9044 37.9223 30.7828 -39.5154 -3.84946 22.9815 +8530 4 23.9949 37.8093 31.2426 42.0603 4.56965 -20.1335 +8531 4 24.7148 38.3736 29.9542 -2.24489 2.04808 -5.58176 +8532 6 2.22015 5.33054 16.4399 10.309 -8.52293 4.98471 +8533 4 1.84892 4.56193 16.8809 -9.36945 -1.25887 4.31387 +8534 4 3.13742 5.05729 16.2666 0.349453 6.20437 -4.74718 +8535 6 1.39717 14.946 19.1428 25.1228 15.6369 3.14315 +8536 4 0.624759 14.5201 18.7755 -11.3456 -6.79531 3.66607 +8537 4 1.29195 14.9418 20.1112 -7.64559 -2.97115 -5.19376 +8538 6 34.323 26.551 23.7054 -6.89575 15.1076 -7.90432 +8539 4 33.5377 26.6273 23.1515 0.482254 10.7241 -2.26295 +8540 4 34.2298 25.6735 24.0419 5.3831 -21.6418 13.1607 +8541 6 41.9187 21.8289 37.5387 -12.5221 18.6557 -0.654717 +8542 4 42.0641 21.2774 38.3263 -4.73604 7.9145 -4.0056 +8543 4 41.3184 22.5612 37.831 11.9642 -17.2916 1.51119 +8544 6 39.4187 37.6728 12.6286 4.8532 5.57593 -2.65087 +8545 4 38.7905 38.0203 13.2933 13.4683 3.10916 -9.30227 +8546 4 40.0129 38.4033 12.3216 -17.7433 -13.1833 12.1033 +8547 6 30.24 35.8848 2.88572 49.7685 -5.59713 18.4489 +8548 4 29.7974 35.0543 2.80033 -9.93294 -19.906 -6.06696 +8549 4 29.6668 36.5692 2.63166 -32.6151 32.1739 -11.9765 +8550 6 50.3574 12.2906 11.0327 -10.5999 -17.0186 -10.0309 +8551 4 50.5337 13.0768 11.5186 9.60091 28.0994 7.49192 +8552 4 50.105 11.6994 11.7365 -4.43527 -18.2768 5.14926 +8553 6 38.4177 1.51331 34.6454 7.78381 -17.0522 33.0946 +8554 4 38.2699 2.04814 33.8899 -7.54861 16.9144 -29.9652 +8555 4 38.0471 0.642488 34.4678 -6.5188 -5.83242 -9.72252 +8556 6 23.4539 32.2409 29.2188 -19.2438 22.9381 45.5983 +8557 4 24.0079 32.8299 28.7229 8.54827 0.527122 -15.0299 +8558 4 23.2413 32.797 30.0413 4.80705 -31.5817 -31.7916 +8559 6 36.5701 38.8746 8.90535 32.3223 -9.33237 29.2552 +8560 4 35.9325 39.4424 8.49935 -20.4423 23.0824 -8.61697 +8561 4 36.7801 39.1579 9.82993 -12.7327 0.605838 -19.3651 +8562 6 35.8737 15.8498 32.4386 8.92141 19.9053 -4.5399 +8563 4 36.1418 15.4504 33.2665 1.19933 -3.86396 7.25653 +8564 4 36.5179 16.5897 32.2945 -14.9335 -15.4114 1.1633 +8565 6 22.2892 21.8291 41.5841 -16.2626 10.7882 17.5339 +8566 4 22.1223 22.8053 41.6744 16.5914 -23.4811 -7.73209 +8567 4 23.1242 21.6534 41.1409 10.4107 9.35007 -4.50107 +8568 6 24.3606 38.6964 37.0146 17.4204 12.5043 -4.63866 +8569 4 25.2779 39.064 36.9978 -17.1771 -5.52971 -1.04157 +8570 4 24.4186 37.9719 37.6407 -4.78215 -9.12154 5.30794 +8571 6 45.8441 22.068 16.038 0.340293 -0.250982 -17.8101 +8572 4 46.1771 22.3609 15.1533 -8.50833 -8.1377 19.1007 +8573 4 45.4344 21.1785 15.9468 10.2139 13.0315 -4.03882 +8574 6 34.0918 26.1359 39.6112 38.0511 -8.91464 13.1738 +8575 4 33.1848 26.2338 39.3827 -25.4265 4.60567 1.8853 +8576 4 34.221 26.2032 40.5833 -12.0295 -1.62025 -11.2558 +8577 6 7.22533 36.1661 23.281 -59.3132 -5.14125 -34.652 +8578 4 7.26364 37.0581 22.9295 6.20379 9.34593 -2.3157 +8579 4 7.97006 36.0735 23.8015 59.451 -4.11437 40.0555 +8580 6 29.1637 40.7448 9.14206 -2.51826 7.72751 -13.9009 +8581 4 29.0444 40.3656 8.22324 15.9504 -2.90487 33.8878 +8582 4 29.7314 40.248 9.77766 -4.36215 -9.31282 -20.9127 +8583 6 29.3678 11.2357 1.30083 -35.1077 14.24 19.1284 +8584 4 28.4669 11.4731 0.940057 29.2946 -5.02339 11.2991 +8585 4 29.318 11.4379 2.27092 4.83193 -7.95866 -28.0539 +8586 6 30.9732 3.71267 14.0776 15.2348 -46.8383 -31.5788 +8587 4 31.4582 2.88428 14.3733 -12.5046 34.6753 7.46482 +8588 4 30.8397 3.49874 13.1133 -3.67459 15.4991 23.3176 +8589 6 29.7056 15.2804 38.2794 -11.9618 14.5562 -33.6413 +8590 4 30.2702 15.1354 39.0168 20.1567 -4.59268 23.419 +8591 4 30.0841 16.0123 37.7308 -6.59039 -15.0688 15.6005 +8592 6 36.6264 0.310111 29.1514 -5.04796 -7.83703 -2.09784 +8593 4 37.4271 0.819379 29.3706 -8.93441 4.46737 -4.0897 +8594 4 35.9914 0.856083 28.6484 15.2391 -5.29618 7.37908 +8595 6 47.6417 0.116275 23.248 13.5287 8.94531 -12.2883 +8596 4 47.0119 0.433387 23.8864 -15.3927 3.59754 12.8324 +8597 4 47.4641 41.0946 23.1357 -2.49679 -12.2922 2.24912 +8598 6 7.90637 37.1762 29.9388 8.54368 22.8184 26.8453 +8599 4 7.85301 37.2098 30.9449 3.45275 -3.37357 -41.2712 +8600 4 8.44496 37.9737 29.6897 -17.0006 -23.7003 10.0801 +8601 6 38.9296 24.2329 12.6383 15.5219 -16.6974 -22.776 +8602 4 37.9787 24.1601 12.7323 -9.9748 0.376678 1.49713 +8603 4 39.1449 23.5705 11.9215 -5.67631 22.059 20.3409 +8604 6 21.3179 26.2613 36.7933 11.7928 19.07 -1.51604 +8605 4 20.8397 25.6962 36.2015 -9.60619 -6.53459 -13.3894 +8606 4 21.5182 25.6957 37.5187 2.0605 -10.1459 21.1123 +8607 6 28.2262 23.3351 24.9913 6.08955 -0.748437 0.460504 +8608 4 28.2308 24.0016 25.6964 4.22655 -6.81745 -1.24962 +8609 4 29.0479 22.8075 25.0363 -13.73 7.51762 2.95505 +8610 6 38.3897 39.5713 14.5774 34.0997 -9.77678 18.0089 +8611 4 38.4779 38.8655 15.2987 -6.58584 29.8461 -29.0755 +8612 4 39.3026 40.0121 14.5422 -41.1029 -19.3921 -1.23505 +8613 6 26.0587 6.01626 38.1331 -7.56489 -16.2073 9.45163 +8614 4 26.364 6.92283 38.0032 14.5247 -0.467326 2.92393 +8615 4 26.7573 5.38712 38.4414 -3.391 26.9876 -7.34507 +8616 6 52.1178 17.2513 22.5128 -10.8492 5.54118 7.42996 +8617 4 52.8997 17.6733 22.1718 9.92427 15.7211 -4.0445 +8618 4 52.2219 16.3395 22.2718 -2.102 -18.0313 -4.16051 +8619 6 39.531 30.2011 31.4754 1.32431 5.33104 20.3977 +8620 4 40.1389 30.6029 32.1578 -26.1612 -12.9519 -10.6425 +8621 4 38.6407 29.9778 31.8528 28.462 12.4065 1.81878 +8622 6 19.6595 6.91666 12.7659 -14.5008 4.80913 14.0157 +8623 4 19.6887 6.47111 13.6446 7.23462 -2.42447 -18.0556 +8624 4 20.266 6.55226 12.115 5.2883 -10.9354 6.21868 +8625 6 32.4266 37.4954 40.1172 13.7501 31.88 -47.4625 +8626 4 32.7425 36.6266 39.9032 -2.48661 -20.9779 5.59445 +8627 4 32.1419 37.5817 40.9958 -11.8933 -10.3197 48.8363 +8628 6 39.7596 0.337115 6.09995 15.1421 -1.66777 24.2876 +8629 4 40.1534 1.22219 6.08152 -5.11901 -0.972083 -7.53812 +8630 4 40.1657 41.8549 6.90018 -9.37436 -2.20237 -11.3555 +8631 6 28.7751 10.1584 29.138 -2.01192 2.80513 -2.93319 +8632 4 27.8238 10.1744 29.001 -3.57801 1.81269 -4.50746 +8633 4 28.8919 9.80572 30.0274 6.34341 -2.0407 -1.56061 +8634 6 28.3442 21.074 10.6333 2.67716 -1.32955 -8.08167 +8635 4 28.7162 21.9756 10.7458 1.68682 -14.6392 -2.70928 +8636 4 28.9848 20.5267 10.1317 -8.30024 16.2649 10.4277 +8637 6 27.0693 28.6863 20.8775 28.7719 -2.37794 4.3254 +8638 4 27.7298 29.2434 21.3283 -4.93173 -3.86203 -1.8773 +8639 4 26.2334 28.9344 21.2444 -24.6691 6.36732 10.1211 +8640 6 39.6873 13.9804 33.4544 10.1398 -5.61125 10.7915 +8641 4 40.0465 13.7022 34.3167 -4.86 2.4669 -10.6871 +8642 4 38.7726 13.6755 33.4723 -5.1401 -2.85022 0.606476 +8643 6 25.4597 11.6576 34.3181 14.491 -28.0098 33.8508 +8644 4 24.8514 11.0162 34.7619 5.36553 12.2612 -15.2396 +8645 4 25.0161 12.1454 33.6493 -21.152 12.7672 -16.4478 +8646 6 27.5131 37.6326 21.427 -19.9573 -21.9997 -23.7283 +8647 4 28.2253 37.2064 20.96 8.67225 -9.05343 -17.242 +8648 4 27.9596 38.068 22.1137 20.557 20.5047 35.0331 +8649 6 30.5914 20.0695 28.6348 27.7431 -17.6396 19.2377 +8650 4 30.9836 19.3645 29.1801 11.8534 20.0629 -12.5158 +8651 4 29.6982 19.8076 28.6872 -39.6618 5.20089 -10.7407 +8652 6 42.3778 1.85684 14.9393 25.4983 -1.50621 30.9456 +8653 4 41.9471 2.41032 15.6124 -5.43016 1.03086 -4.74891 +8654 4 41.8361 1.80616 14.1675 -19.8596 2.00334 -17.6468 +8655 6 12.1616 12.5321 19.523 -14.5305 -6.69845 -4.01711 +8656 4 12.9939 12.0448 19.446 -0.641831 -5.10207 -0.17564 +8657 4 11.4028 11.9007 19.4323 17.6183 8.93718 0.635936 +8658 6 19.2173 1.21358 16.3673 12.2327 1.89672 9.92834 +8659 4 19.755 0.600796 16.911 -5.77615 9.45405 -9.5745 +8660 4 19.8129 1.9499 16.1364 -2.75311 -6.47505 -0.557351 +8661 6 9.48027 16.145 27.6887 18.4383 23.7652 -21.1678 +8662 4 9.95062 16.009 26.8224 -12.6846 -2.19341 25.2173 +8663 4 9.19893 15.3052 28.0262 -3.30777 -17.5687 0.945009 +8664 6 40.4566 26.1709 24.7821 -20.4805 41.2174 -0.532491 +8665 4 40.3628 26.7039 25.5991 10.1463 -19.7663 1.05084 +8666 4 40.0809 26.8306 24.1463 10.2053 -25.1837 1.88999 +8667 6 47.6675 17.6506 18.0225 -30.0634 41.3074 12.2788 +8668 4 48.2543 17.9981 18.7254 0.401995 -10.3127 -9.33209 +8669 4 46.9068 18.3177 18.0388 29.0716 -28.5939 -1.2112 +8670 6 36.6158 25.2629 4.18774 29.3736 28.0527 4.32129 +8671 4 36.5214 25.5758 5.09839 -16.0305 -5.04511 0.138651 +8672 4 37.2819 25.9232 3.86538 -16.6324 -17.2389 -6.3952 +8673 6 39.5728 35.3879 29.6636 12.278 22.7044 -7.26925 +8674 4 39.0499 34.5938 29.661 -5.91236 -8.06683 2.48368 +8675 4 39.3907 35.9006 30.4607 -1.7908 -9.53931 -1.38728 +8676 6 0.412001 14.6096 13.3342 2.26376 -2.5079 -14.7045 +8677 4 54.7802 15.2759 13.6175 -3.32355 6.27336 -0.974202 +8678 4 0.516441 14.0579 14.0961 4.60085 -12.9246 15.0473 +8679 6 12.196 27.3305 8.43326 10.0473 13.6833 14.0535 +8680 4 13.031 26.8669 8.51701 2.31971 -16.5604 -6.51009 +8681 4 12.4357 28.1833 8.85089 -17.0888 -3.60228 -10.1051 +8682 6 36.9057 14.8161 21.1198 30.6025 20.2317 -25.7914 +8683 4 37.0125 14.4244 21.9807 1.92342 -10.2074 20.832 +8684 4 37.7936 15.2053 20.874 -24.9082 -16.5351 5.08732 +8685 6 20.8486 4.94275 21.105 17.9022 -6.61396 -0.309651 +8686 4 20.374 5.67415 21.5228 9.17185 2.06744 3.08402 +8687 4 21.7751 4.88103 21.448 -24.8745 1.45604 -2.42669 +8688 6 36.7441 1.80601 7.63303 -8.86792 14.8212 -18.8361 +8689 4 36.3577 2.71345 7.77493 14.0998 -30.8697 16.0099 +8690 4 36.9898 1.34966 8.45182 -6.21638 14.7491 3.51078 +8691 6 12.2291 31.5076 37.4606 -20.8205 4.71929 16.9336 +8692 4 12.7789 31.2189 36.7301 -1.71439 -5.19212 -6.77065 +8693 4 11.3837 31.0118 37.4916 13.4088 3.21935 -3.86138 +8694 6 38.9875 41.6041 16.8806 -4.97036 -4.86794 -9.64455 +8695 4 39.4307 41.5716 16.0177 3.10466 0.790549 7.7281 +8696 4 39.367 0.410173 17.3903 6.57234 9.13046 2.45051 +8697 6 31.8971 27.2651 22.2536 0.475946 9.95506 -26.8482 +8698 4 31.2288 26.6192 22.5148 1.53167 3.01995 -0.700727 +8699 4 31.6701 27.5469 21.3168 1.33988 -13.0026 32.8364 +8700 6 42.7373 9.18402 25.5752 -16.5205 -8.12573 12.5156 +8701 4 42.0715 8.82875 24.9549 8.97347 3.93682 -3.18445 +8702 4 43.4726 9.55718 25.0966 9.17117 4.66181 -14.1392 +8703 6 50.9317 28.1762 25.3585 1.81467 11.9603 16.0249 +8704 4 50.4332 27.6858 24.699 -7.797 -4.30978 2.61883 +8705 4 50.6061 27.9816 26.259 1.82058 -3.16123 -16.2825 +8706 6 43.2019 19.6758 30.9261 -60.5069 12.608 18.1565 +8707 4 44.1121 19.7947 30.8273 58.227 11.7487 -4.80009 +8708 4 42.8317 20.4979 31.3452 14.2318 -14.5845 -6.94071 +8709 6 30.6579 14.0392 40.8099 -3.90856 28.8453 32.4485 +8710 4 30.2625 14.437 41.6588 6.78025 -22.1962 -33.7862 +8711 4 30.2388 13.192 40.6401 -8.31431 -9.09038 5.19898 +8712 6 20.9126 15.487 23.0255 1.81996 -1.2716 -0.577536 +8713 4 20.3529 16.1851 23.4151 9.86352 -5.06847 -1.26552 +8714 4 21.845 15.6804 23.2451 -11.0139 0.781722 1.09061 +8715 6 34.2266 0.759926 35.8266 5.91607 -35.831 36.3238 +8716 4 34.6699 1.4486 36.3596 -6.19332 -9.6922 -6.67054 +8717 4 34.0788 41.8551 36.4474 5.42693 41.8664 -30.5853 +8718 6 38.9146 36.9114 35.918 21.2173 -10.8751 17.2864 +8719 4 39.7829 37.095 36.338 -12.434 5.66027 -11.9648 +8720 4 38.7157 36.033 36.27 -5.46808 2.11761 -7.10044 +8721 6 45.1412 25.209 22.7799 -9.21588 11.7282 35.1943 +8722 4 44.1635 25.1535 22.9277 18.3683 -4.67801 -8.38153 +8723 4 45.395 24.8019 21.9606 -9.08047 -9.94082 -17.9945 +8724 6 40.6079 0.819632 35.9543 -10.1658 30.0784 -5.29357 +8725 4 40.5743 41.7978 35.9297 8.39322 -37.6139 4.80851 +8726 4 39.8853 1.04128 35.3423 10.5918 6.58535 9.58714 +8727 6 11.0481 28.354 35.0263 -7.05837 2.15472 6.15391 +8728 4 11.0065 27.7661 35.7937 6.20016 -1.50115 -1.31869 +8729 4 10.2774 28.923 35.1598 -2.00076 2.29074 -4.05614 +8730 6 20.214 13.5993 35.8619 28.0429 -16.4719 23.5579 +8731 4 19.4963 13.9327 35.3857 -45.1468 12.1599 -23.9045 +8732 4 20.9404 14.0304 35.4284 21.7873 4.64258 -6.99651 +8733 6 39.6259 5.13927 1.77541 6.3837 10.5905 23.0009 +8734 4 38.815 4.76887 1.43754 -8.89155 -4.8304 -7.9643 +8735 4 40.2998 5.10051 1.09544 5.70124 1.55861 -13.0764 +8736 6 30.2644 30.8765 32.4376 2.45351 13.5189 11.7538 +8737 4 29.6638 31.1848 33.1457 1.37952 -7.29152 -6.97913 +8738 4 29.9065 30.0722 32.0512 -6.5155 -7.29863 -0.0927806 +8739 6 14.5561 10.991 22.8667 10.081 16.7623 43.7388 +8740 4 15.1677 11.6459 23.3133 -13.9792 -18.4015 -26.7579 +8741 4 13.9431 10.829 23.6181 3.59137 -7.6484 -17.8174 +8742 6 20.7554 13.9367 3.0184 -22.7431 -13.2276 -14.851 +8743 4 19.9027 13.7405 2.57467 24.082 -4.954 3.77469 +8744 4 20.4786 14.7044 3.49738 5.42185 19.6619 18.2233 +8745 6 41.2999 4.28373 12.6115 -5.11846 11.2121 16.06 +8746 4 40.5902 3.66826 12.7964 -5.45414 -3.74116 2.1628 +8747 4 41.646 4.04628 11.766 6.8814 -9.70345 -22.8074 +8748 6 10.8486 24.7151 21.7079 -22.0181 20.7635 -2.99902 +8749 4 10.06 25.055 21.1824 26.1755 -20.3138 8.68391 +8750 4 11.196 23.8735 21.3742 -8.74412 -0.217035 -8.2032 +8751 6 53.5851 20.8962 34.3615 -20.5776 4.99959 -7.54911 +8752 4 54.5312 20.9399 34.3174 23.7346 3.60458 -0.717784 +8753 4 53.3344 20.0378 34.731 7.46747 5.54606 -4.26157 +8754 6 14.8822 4.84805 30.4483 -9.71325 -6.00753 -19.6684 +8755 4 14.771 4.94284 29.4789 1.77408 0.90497 14.7496 +8756 4 14.5561 3.94513 30.5986 4.49673 6.24836 5.5759 +8757 6 48.9024 37.1196 13.1149 -36.5603 24.8322 -14.1851 +8758 4 47.9606 37.2057 13.4129 22.1922 -3.12109 -3.19476 +8759 4 49.2987 36.4589 13.6532 13.3268 -16.5999 12.901 +8760 6 26.8059 19.3169 7.54434 -4.26945 -4.42367 7.83904 +8761 4 27.1766 18.4867 7.22339 -3.92405 -4.32352 -1.07463 +8762 4 27.3968 19.9842 7.20607 8.782 12.6164 -5.40832 +8763 6 17.6305 11.9358 39.0864 -20.6439 9.19078 16.9487 +8764 4 18.5077 11.609 39.0209 28.8526 -12.5757 -8.06323 +8765 4 17.5232 12.1203 40.0373 -6.81014 1.23205 -8.73836 +8766 6 49.927 14.591 8.61416 15.5742 -26.1486 -8.96269 +8767 4 49.2009 13.9524 8.72368 2.87529 10.9098 3.94828 +8768 4 49.6414 15.4659 8.85563 -10.1676 20.5637 7.32703 +8769 6 32.3582 34.9735 31.5167 -0.414276 11.4895 24.1707 +8770 4 32.1283 34.3825 30.8126 -1.81559 -4.89127 -12.898 +8771 4 32.4479 35.8663 31.1601 -0.97656 -3.19104 -3.1743 +8772 6 11.821 22.2226 21.3194 1.12988 -20.2292 -31.7924 +8773 4 12.2035 21.6949 20.5593 -17.646 16.3031 19.3587 +8774 4 12.5076 22.1609 21.967 14.4856 1.86701 17.8995 +8775 6 33.8479 9.95925 13.6297 5.85555 4.94861 0.641841 +8776 4 32.9412 9.60258 13.4965 20.4646 2.44791 -13.0803 +8777 4 34.46 9.81143 12.8638 -25.0852 -4.3509 9.75457 +8778 6 25.5216 36.3896 1.4985 -3.83916 -1.90754 -5.44184 +8779 4 26.1733 36.851 0.947779 -3.43756 3.58217 3.68691 +8780 4 24.6678 36.8514 1.38848 10.8858 -3.23471 -1.95008 +8781 6 26.2654 10.5456 9.75524 -44.5011 8.64206 25.1655 +8782 4 25.6084 11.269 9.60979 18.788 -4.56637 -6.88642 +8783 4 25.8198 10.0845 10.5139 21.0346 7.54764 -16.1236 +8784 6 25.0247 0.792222 40.9035 16.6629 9.7536 -9.8108 +8785 4 25.2766 0.410293 40.0414 -7.0744 -0.853038 7.71488 +8786 4 25.4535 1.67289 40.8914 -6.39875 -10.0211 5.33714 +8787 6 46.2514 3.92331 24.811 2.29787 -10.4124 3.565 +8788 4 46.4476 4.07649 23.8793 1.84574 -7.0337 -1.43198 +8789 4 46.0806 2.96577 24.928 -3.00701 8.9366 -8.52535 +8790 6 21.593 13.605 29.211 2.46069 1.87638 12.7155 +8791 4 21.5518 14.2847 29.9136 -0.977025 -6.07097 -8.18011 +8792 4 21.3035 14.062 28.4178 -1.02829 3.62716 -1.29843 +8793 6 36.772 38.3747 0.364057 -13.57 -14.6746 -5.92565 +8794 4 36.4241 39.1227 0.863015 -2.10343 5.30459 -0.282121 +8795 4 36.0255 37.7419 0.250491 13.2024 11.0478 3.68109 +8796 6 19.3024 17.6377 24.0664 34.4056 30.1631 -22.0465 +8797 4 18.4191 17.3498 24.1437 -40.9446 -15.7866 5.54764 +8798 4 19.2946 18.2748 23.3003 0.347271 -14.2409 17.5238 +8799 6 23.1729 12.6936 3.50527 -23.4203 -1.67393 -9.32385 +8800 4 22.2599 12.987 3.28408 10.1497 2.83055 6.60862 +8801 4 23.2366 11.8468 3.05081 2.04707 -0.882582 2.79058 +8802 6 37.8929 8.88926 35.4532 -15.1513 -19.5409 -35.7954 +8803 4 38.8496 8.85033 35.2802 -3.80753 -1.00094 -0.145651 +8804 4 37.4409 8.32345 34.738 24.7998 24.8105 28.8968 +8805 6 14.3214 15.124 36.1936 10.1777 -8.45579 -11.337 +8806 4 15.1189 15.6285 36.3983 0.383997 -0.909139 3.4786 +8807 4 13.728 15.2114 36.9249 -8.84751 6.7001 14.2991 +8808 6 35.0764 0.951221 33.027 4.39995 -0.747562 -23.3066 +8809 4 34.9707 1.92678 33.0471 -0.901583 -14.825 16.9845 +8810 4 34.929 0.489106 33.8671 -4.79444 18.9729 2.67887 +8811 6 50.9368 0.508345 17.9996 -16.1068 -2.11236 -10.8013 +8812 4 50.7363 1.3993 17.6607 6.59543 -7.82408 5.75367 +8813 4 50.2126 41.8571 17.6452 15.113 5.01242 7.08044 +8814 6 26.2276 30.5707 0.943679 2.98972 25.4521 29.679 +8815 4 26.9747 31.0717 1.30878 -11.5718 -5.07384 -0.177367 +8816 4 26.5685 30.1289 0.190254 7.28539 -15.5247 -23.6744 +8817 6 18.5631 38.2963 4.56281 15.0547 -0.00169581 -1.07608 +8818 4 17.6313 38.4808 4.44067 -9.04909 6.52025 -3.84653 +8819 4 19.0145 38.7079 3.79419 -7.75189 -5.39823 9.30868 +8820 6 31.1327 5.08368 4.10816 20.0095 -18.3558 -6.33253 +8821 4 31.8391 4.51927 4.54922 -26.0459 18.0586 -17.7145 +8822 4 31.2112 4.96997 3.12633 -1.20575 2.29654 19.098 +8823 6 26.4386 21.9021 1.48262 11.6176 -12.3641 -2.34526 +8824 4 26.4119 22.77 1.11333 -7.24657 26.8604 -8.21156 +8825 4 27.3591 21.6321 1.37052 -1.3799 -4.61827 0.12427 +8826 6 39.218 11.6975 22.8013 10.5737 17.0434 4.86912 +8827 4 39.8837 11.6898 23.5135 -8.12783 -9.21376 -3.17514 +8828 4 38.7576 10.8611 22.7762 -0.316566 -9.51531 5.7902 +8829 6 13.6104 36.3454 30.6448 12.2201 31.8005 15.4331 +8830 4 13.9411 37.0787 31.1944 -5.64032 -6.12374 -20.8561 +8831 4 13.4819 35.6769 31.3099 -5.82879 -19.5305 -1.97286 +8832 6 50.5737 9.8729 9.34449 -28.5439 -15.8542 -0.594603 +8833 4 49.6941 9.5296 9.68217 24.5077 10.0039 -8.16891 +8834 4 50.7802 10.6382 9.87905 1.56032 8.49656 8.37591 +8835 6 49.6568 40.2957 22.5808 3.13406 -4.17489 -1.45496 +8836 4 49.9643 39.4131 22.2832 -6.04563 10.523 5.74674 +8837 4 49.4657 40.2311 23.537 6.08697 -6.10842 -7.72776 +8838 6 7.19984 41.3227 28.8903 -1.52952 20.6044 28.9443 +8839 4 7.18166 41.5789 29.8666 2.82963 -8.74683 -37.3978 +8840 4 7.33954 0.237732 28.3754 1.09714 -11.2116 9.436 +8841 6 13.0357 18.018 25.3358 19.442 16.9905 44.3108 +8842 4 13.6166 18.1186 24.5548 -1.12298 4.17303 17.3747 +8843 4 13.5323 18.3306 26.2146 -21.9746 -20.4015 -59.5043 +8844 6 50.052 19.589 2.43093 38.9512 -4.48133 -22.8803 +8845 4 50.7424 19.2598 1.79532 -23.4729 1.49397 14.1456 +8846 4 50.5528 20.298 2.8491 -7.87613 8.00017 8.65361 +8847 6 28.349 40.9814 24.5177 14.9096 -9.01222 -0.77751 +8848 4 28.8235 40.5955 23.7606 -4.31864 4.07524 4.80921 +8849 4 27.7156 41.5877 24.1507 -14.6867 11.3415 -7.76415 +8850 6 19.4129 5.36023 29.5381 -15.1481 -17.3665 11.3948 +8851 4 20.1134 5.96028 29.2689 3.1753 8.4576 0.913483 +8852 4 18.7407 5.8353 30.064 8.44892 1.72514 -6.85652 +8853 6 35.3149 40.1584 22.2743 -5.4761 3.67764 -22.0922 +8854 4 35.6772 39.8166 23.0859 3.70556 0.822605 11.3301 +8855 4 35.3088 41.1243 22.2924 6.6179 -0.993945 11.5959 +8856 6 16.1846 33.7767 9.75922 -0.358556 8.53088 17.0233 +8857 4 15.9516 33.2005 9.03859 1.48669 -13.8429 -11.0903 +8858 4 15.6081 34.5411 9.70154 -4.21994 3.45608 -1.0308 +8859 6 17.3638 40.6569 20.2187 0.0478101 13.797 12.0053 +8860 4 17.2553 39.7868 20.6094 -1.96745 -8.64858 -4.42208 +8861 4 17.5346 41.2369 20.9867 0.609446 0.00823871 -10.958 +8862 6 20.5168 9.71855 9.57392 23.3053 8.23996 -15.5036 +8863 4 21.1612 10.0129 10.2371 -5.46071 -1.58749 -5.90152 +8864 4 19.8092 9.36498 10.0856 -20.4585 -11.5711 12.7624 +8865 6 47.4431 20.1927 21.3797 46.3705 -23.5901 12.8176 +8866 4 48.2534 19.5912 21.2825 -32.1103 24.8918 7.30718 +8867 4 46.9863 20.0806 20.5604 -17.463 -0.0836882 -22.1962 +8868 6 38.4119 40.7863 37.8131 4.58972 -16.3007 -8.86139 +8869 4 38.2015 41.716 37.7675 -2.07213 19.1933 -0.538509 +8870 4 38.1163 40.4897 38.6817 -2.89344 0.451293 5.51523 +8871 6 4.78246 1.95264 13.1142 -0.962758 -11.3299 -4.56483 +8872 4 4.86308 1.24617 12.4504 1.09441 11.0888 1.2667 +8873 4 4.58181 1.48453 13.9266 -0.88642 0.622503 9.15822 +8874 6 46.8366 29.0044 2.17213 -21.5573 10.7483 2.0879 +8875 4 46.5703 29.0979 3.11526 14.9241 -10.138 -17.8178 +8876 4 47.6533 28.5191 2.04264 7.39387 -6.09514 13.7966 +8877 6 37.4332 26.1628 25.6457 0.476866 -1.57884 -3.35254 +8878 4 37.1432 25.5044 26.2761 -1.46501 -6.7424 3.65975 +8879 4 36.6379 26.5951 25.3475 -3.92424 6.80267 -0.609098 +8880 6 27.3215 4.19863 19.437 6.03131 -5.89417 1.59018 +8881 4 28.0693 4.5088 18.8685 -19.6633 0.0824503 4.70742 +8882 4 26.4692 4.57526 19.1444 8.48727 3.90116 -6.43998 +8883 6 29.5816 35.1763 32.6702 11.3433 -15.1984 -13.0035 +8884 4 29.498 34.4257 32.0309 -0.34209 19.1564 15.9908 +8885 4 30.487 35.489 32.5363 -2.16348 -1.10322 -0.755163 +8886 6 51.6039 27.3804 34.6228 -16.2846 20.7721 3.47149 +8887 4 51.9118 26.5342 34.8842 8.46829 -31.6815 14.0056 +8888 4 52.043 27.5552 33.7939 4.07896 7.882 -12.2594 +8889 6 26.213 15.718 22.6983 4.45652 -13.2698 4.19624 +8890 4 25.9644 16.5706 22.3629 -2.74203 26.12 0.0562263 +8891 4 25.9462 15.1046 22.0171 -4.99078 -11.3651 -6.14484 +8892 6 36.1284 41.1872 15.4686 -15.9675 5.34592 -0.326298 +8893 4 35.5872 40.4009 15.2728 11.0637 0.363161 -0.898578 +8894 4 37.0593 40.962 15.4319 4.98109 -12.2962 -3.97184 +8895 6 18.4605 8.81439 11.2163 9.85092 25.9028 -2.05591 +8896 4 18.8222 8.21565 11.8732 -2.65799 -9.87079 3.83174 +8897 4 17.6938 8.4288 10.8111 -9.58752 -11.4871 -1.05984 +8898 6 30.2054 21.3176 23.2008 0.0321998 2.06754 0.100272 +8899 4 29.9991 22.2239 22.9456 -2.76699 -3.99559 -1.97847 +8900 4 29.5697 20.7243 22.7648 2.21136 7.68347 0.454199 +8901 6 22.7376 2.20942 34.8415 -7.06988 -25.8748 21.345 +8902 4 22.3263 1.32441 34.7915 6.81547 13.2405 5.99888 +8903 4 22.6443 2.51876 33.959 0.748808 17.6695 -28.972 +8904 6 12.6779 2.74229 12.3423 -3.02369 13.9186 -14.8572 +8905 4 12.6684 3.63953 11.9163 1.20981 -22.4864 12.4813 +8906 4 13.1874 2.20366 11.7175 -0.841633 0.53426 4.77071 +8907 6 24.0891 30.0714 14.5767 2.26717 -13.4561 -11.586 +8908 4 23.8674 30.8343 15.1637 -15.8173 -12.4528 -15.4046 +8909 4 23.3482 29.6562 14.0436 11.1594 27.3113 22.4963 +8910 6 0.0169515 27.9037 22.8558 -22.9231 2.02358 -4.19556 +8911 4 54.5653 28.3586 23.5905 7.88497 -1.22395 1.09473 +8912 4 54.2173 27.7016 22.3138 13.4725 -1.40758 1.11908 +8913 6 12.3768 4.48401 25.8984 -1.01368 1.72138 -1.86924 +8914 4 11.999 5.34556 25.8124 1.61778 23.022 -11.6285 +8915 4 11.6412 4.07623 26.3496 -0.520107 -24.5543 7.98643 +8916 6 50.6552 14.4595 5.90563 -9.7075 2.6569 37.2621 +8917 4 51.421 15.0215 5.71422 1.2699 0.536098 -2.53407 +8918 4 50.4862 14.5526 6.9139 5.60038 -4.97296 -46.1729 +8919 6 52.566 22.8545 20.1304 -1.0263 1.56712 -17.1158 +8920 4 52.8493 23.3468 20.8979 1.30497 -0.175929 17.7779 +8921 4 52.7622 23.494 19.4302 -3.4332 -7.01119 -2.14697 +8922 6 43.5747 16.5432 12.8706 26.1082 -6.15301 -20.1459 +8923 4 44.3581 16.1075 12.4177 -27.2623 16.7463 17.9516 +8924 4 42.8105 16.3628 12.3102 -5.85283 0.59737 -2.51971 +8925 6 15.9643 16.7491 40.5889 4.71604 31.6512 -1.38133 +8926 4 16.4157 17.2981 39.8953 -10.7397 -16.8436 16.4649 +8927 4 15.6568 17.4119 41.253 8.12177 -13.8769 -14.2686 +8928 6 23.4093 18.8548 23.8539 -16.419 -4.21219 2.12821 +8929 4 23.4427 19.3457 24.6888 0.296298 -1.81048 -2.30579 +8930 4 22.5005 18.9913 23.5305 9.65682 -2.29273 2.24785 +8931 6 46.4286 3.27372 31.8783 1.50761 -1.36157 -5.63512 +8932 4 45.559 3.26328 31.468 -2.27736 -0.687336 -10.0334 +8933 4 46.2409 3.35124 32.8099 7.04458 2.11131 4.36323 +8934 6 43.404 41.0501 12.2894 -4.74196 -21.563 6.60959 +8935 4 43.6943 41.7945 12.8025 5.82787 10.392 6.16968 +8936 4 43.4921 41.2918 11.3656 -0.276957 5.00436 -10.4807 +8937 6 7.4944 32.479 29.5886 4.16519 42.7458 -9.72808 +8938 4 8.11522 31.7905 29.7504 15.4265 -22.4366 1.70525 +8939 4 8.06583 33.2868 29.4339 -18.9062 -19.2919 1.43274 +8940 6 4.77786 31.6555 22.5097 8.01353 -0.237295 6.09653 +8941 4 5.36252 32.2279 23.0433 -12.0801 1.27555 -9.50519 +8942 4 4.10079 32.1892 22.0697 5.55495 3.82082 5.5049 +8943 6 48.8707 26.8644 2.67473 3.24755 -50.1854 9.90243 +8944 4 49.7841 26.6767 3.05593 -33.5394 4.93648 -17.7122 +8945 4 48.3402 25.9967 2.74374 27.3415 43.0547 -3.91521 +8946 6 35.3704 23.2724 21.6151 -20.572 -8.60634 18.7236 +8947 4 36.1531 22.7653 21.8467 10.3528 0.763668 -1.9928 +8948 4 35.5272 23.8633 20.8878 14.153 10.3741 -19.8739 +8949 6 9.81162 37.7752 27.3066 -7.93747 -1.88745 -15.4111 +8950 4 9.56608 38.5967 27.7736 11.3364 -13.9943 4.65066 +8951 4 10.53 37.2723 27.7168 -2.00951 8.75096 9.6206 +8952 6 6.95784 10.9804 26.0002 -14.8513 -9.26658 -13.6642 +8953 4 6.43708 10.2284 25.6287 17.7452 16.2397 9.86134 +8954 4 7.32481 10.7062 26.8445 2.87033 -7.35616 11.341 +8955 6 15.9925 34.488 38.9165 -7.91378 13.4212 -4.2482 +8956 4 16.1125 33.5888 38.5756 -0.423195 -0.537141 7.5048 +8957 4 15.8451 34.497 39.8859 4.12272 -10.609 -16.5735 +8958 6 24.136 17.3087 36.1669 -1.30362 -38.1211 0.134245 +8959 4 24.6388 17.5417 36.9612 2.54889 -4.89456 5.81445 +8960 4 24.0565 16.298 36.169 6.29988 31.3296 1.89661 +8961 6 29.9661 19.0481 5.63552 -3.51045 -24.0694 26.081 +8962 4 30.059 18.4844 6.44318 1.40084 7.89656 -22.1005 +8963 4 29.4651 19.7932 5.9612 -6.50009 17.0844 0.645364 +8964 6 41.2323 14.2118 25.8708 0.538972 29.9242 -13.4546 +8965 4 41.1167 15.1135 25.4912 3.21098 -20.1981 4.76589 +8966 4 41.3237 14.3734 26.8138 2.01946 -2.10135 6.77926 +8967 6 30.5977 17.7991 37.3648 -2.09385 13.2702 -7.29075 +8968 4 30.1274 18.3693 36.6865 13.7219 -8.47854 26.2153 +8969 4 30.6897 18.2674 38.2325 -7.09621 1.58925 -18.9017 +8970 6 36.2622 35.7606 28.8616 -21.9344 -15.8478 13.9239 +8971 4 36.666 34.9659 29.2737 0.470987 14.2463 -5.72758 +8972 4 36.9609 36.34 28.5862 17.8584 7.52692 -3.58957 +8973 6 0.186361 37.881 20.3783 -19.4052 1.06805 -13.5296 +8974 4 0.625244 37.258 20.9754 1.43275 1.23053 -1.08677 +8975 4 54.3963 37.4077 20.0073 13.2242 8.68111 6.51083 +8976 6 49.5157 39.5849 25.2719 1.34086 -27.0873 28.6785 +8977 4 49.1738 39.8396 26.1677 9.83442 -4.23573 -27.15 +8978 4 49.8309 38.6394 25.3482 -11.1501 31.2987 0.525887 +8979 6 21.6501 10.2052 29.3652 1.38747 -32.8599 -17.8213 +8980 4 21.4815 11.1062 29.1158 -2.57329 19.5966 11.1399 +8981 4 21.7962 10.0736 30.3036 1.32123 13.0863 10.38 +8982 6 36.4484 30.062 0.133613 20.0221 49.2239 1.07318 +8983 4 36.3691 29.4748 41.3122 -8.72629 -28.1564 -18.1683 +8984 4 36.9877 30.812 41.6437 -16.8233 -22.5363 23.3328 +8985 6 35.2366 23.3806 39.1473 20.2218 -67.2813 -35.6269 +8986 4 34.8925 23.3776 38.2436 -2.85003 -5.00903 7.3464 +8987 4 34.9678 24.1769 39.4749 -24.7984 75.1446 29.9953 +8988 6 25.4958 17.6356 38.7131 -1.05403 5.23051 -13.5311 +8989 4 26.2557 17.1099 38.9745 11.6052 -6.82876 2.03202 +8990 4 25.6896 18.4914 39.1039 0.551448 5.55093 4.31103 +8991 6 32.6851 1.71412 15.3757 -17.1832 -26.0249 32.2484 +8992 4 32.9133 1.90091 16.3255 -0.281287 1.06348 -22.8896 +8993 4 32.1369 0.878474 15.451 14.5551 28.5253 -7.92953 +8994 6 2.74577 26.2334 40.164 -3.83079 -17.2464 -24.8373 +8995 4 2.52975 26.8073 40.8689 -10.0885 25.811 23.4985 +8996 4 3.46379 25.6906 40.4857 13.7859 -11.3271 -3.22577 +8997 6 25.4247 39.5803 6.65235 -3.20662 25.1889 -29.4644 +8998 4 26.0108 39.0547 7.19361 -10.0861 -10.9475 13.3666 +8999 4 24.4797 39.508 6.87242 11.3389 -11.2764 10.0712 +9000 6 3.89558 2.45526 21.1915 20.3615 -74.5786 -16.468 +9001 4 3.45835 1.54866 20.9342 19.9424 46.4596 11.9477 +9002 4 3.20863 3.06758 21.3193 -35.5841 29.5388 2.2294 +9003 6 19.428 35.9937 6.17834 -35.0483 8.79483 10.2733 +9004 4 18.6638 35.8781 6.77432 14.6839 -5.07873 0.0324743 +9005 4 19.0495 36.6291 5.56439 9.71061 8.85688 -10.7695 +9006 6 53.6717 10.8593 34.7958 -7.0633 -31.3632 -8.45381 +9007 4 53.6341 10.4895 35.6991 7.39736 18.8685 -12.2464 +9008 4 53.8829 11.7827 34.7263 4.03482 19.5096 16.0301 +9009 6 51.2684 14.0949 34.672 -8.65676 -1.63762 -26.9588 +9010 4 50.7715 13.5641 33.9816 13.3581 12.906 22.4054 +9011 4 51.0369 13.7812 35.5532 -5.90867 -9.66849 3.74112 +9012 6 14.4369 40.0234 28.032 -17.7583 12.3896 33.8878 +9013 4 13.8707 39.2432 27.9284 6.73847 -3.79593 -5.43806 +9014 4 14.0697 40.4885 28.8439 14.5888 -10.3946 -25.5694 +9015 6 36.0586 40.8581 1.30985 34.3129 5.11816 -1.28261 +9016 4 35.3876 41.022 1.96214 -5.4524 5.11716 12.4526 +9017 4 36.8901 41.3246 1.61712 -30.5352 -10.0787 -2.88322 +9018 6 32.5955 21.8673 9.61487 11.2903 3.47268 22.8686 +9019 4 32.2562 21.1899 9.03409 -3.19899 -6.31213 -16.1683 +9020 4 32.8032 22.6511 9.09762 -2.66985 0.307575 -11.8305 +9021 6 53.7554 11.4583 10.0657 12.5408 -15.0223 -21.3323 +9022 4 54.7025 11.5478 10.261 -4.15933 2.55001 3.12883 +9023 4 53.7605 10.7769 9.36125 -9.51558 7.63224 9.70748 +9024 6 25.4365 2.06658 35.0039 -16.8474 18.4627 -14.151 +9025 4 25.5892 2.94197 34.5728 -1.09755 -16.5277 9.12484 +9026 4 24.4603 2.05675 35.1439 15.8828 -2.54758 -2.86629 +9027 6 38.4258 16.3759 27.0837 10.3035 -3.82582 33.4754 +9028 4 38.4229 16.0362 28.0039 4.2105 -6.34073 -14.2668 +9029 4 38.1536 17.2766 27.2341 -1.96409 14.1736 -9.55492 +9030 6 11.9898 11.8134 38.076 -13.826 -2.82892 7.4824 +9031 4 12.2944 12.4411 38.7385 15.2198 2.85174 -2.31876 +9032 4 11.0532 11.721 38.3132 2.05768 -5.32701 -10.6008 +9033 6 21.1746 40.7334 25.8979 40.4357 -13.6237 -24.6728 +9034 4 20.6698 41.4315 25.4918 -16.6357 14.348 -0.996217 +9035 4 20.789 40.494 26.7242 -19.3448 -1.94923 24.9485 +9036 6 5.46053 31.2633 28.1043 10.2831 7.82506 0.3012 +9037 4 4.85681 31.7249 27.5011 4.53193 2.9664 -2.03256 +9038 4 6.18919 31.875 28.3487 -9.19227 -4.78386 -2.03476 +9039 6 38.5722 10.4288 26.6273 1.75688 -6.42268 2.69181 +9040 4 39.2722 10.957 26.2192 0.13713 -2.38088 1.965 +9041 4 38.9883 9.93745 27.351 -0.726559 6.62326 -4.692 +9042 6 34.5654 22.2334 5.77474 -10.6824 6.04198 20.2303 +9043 4 33.6505 22.4646 6.03122 6.34024 -5.77168 -8.80249 +9044 4 35.1097 22.5906 6.49609 1.67963 -6.25138 -9.01327 +9045 6 19.5088 23.4111 8.91157 10.1707 -16.3121 14.7533 +9046 4 19.7449 23.1021 9.7973 -5.16612 6.6008 -0.0119594 +9047 4 19.9964 22.8054 8.35541 -0.106246 2.40248 -11.9056 +9048 6 19.7526 39.1673 18.9392 3.41392 2.41259 -7.44399 +9049 4 20.3112 38.9942 19.7162 -9.66179 4.90282 -1.08801 +9050 4 18.9888 39.695 19.2431 8.6955 -6.10904 -0.220035 +9051 6 19.0066 16.6479 37.8897 24.9266 -16.0788 2.00499 +9052 4 18.1904 16.5622 37.4269 -20.8911 -0.0800444 -12.5516 +9053 4 18.858 17.3198 38.5387 -2.83386 13.0664 11.2213 +9054 6 46.1457 18.3015 34.4662 -13.7163 3.02283 10.6817 +9055 4 46.1788 17.7584 33.6837 2.50627 -7.36872 -12.652 +9056 4 45.2295 18.6352 34.4793 7.83367 -3.11582 0.242547 +9057 6 37.6724 4.92727 10.6572 20.6306 -0.498941 -29.5329 +9058 4 38.5268 5.23995 10.2493 -20.9001 -6.48587 16.5696 +9059 4 37.1025 4.69637 9.88262 10.9132 7.05613 26.3995 +9060 6 51.9879 36.0003 6.84307 -0.0349375 1.28893 10.7684 +9061 4 52.0937 36.793 6.30051 2.19835 -5.62517 4.5242 +9062 4 52.7425 36.0295 7.48232 -7.26034 2.01661 -20.7899 +9063 6 26.6747 12.3215 0.993928 -15.5873 -26.456 -19.7503 +9064 4 26.4829 12.3908 1.92985 -0.4811 3.80705 11.7504 +9065 4 26.1241 11.5295 0.732228 15.7893 19.669 4.48242 +9066 6 51.344 35.7707 13.5244 -1.45768 15.8539 -2.86245 +9067 4 51.4515 36.3837 12.7824 1.55721 2.40741 1.90229 +9068 4 51.4783 34.9191 13.1366 6.57206 -21.9808 -6.55402 +9069 6 1.98876 3.63996 24.5779 3.53339 50.093 -23.5227 +9070 4 1.66274 3.05681 25.2088 -14.7773 -39.8355 33.4132 +9071 4 1.68527 4.50485 24.9411 8.95614 -12.6616 -11.2736 +9072 6 33.5242 15.2767 16.4494 0.0755523 4.59339 -41.038 +9073 4 33.5553 15.5138 15.4787 -3.36737 -9.15609 28.4742 +9074 4 33.81 16.089 16.8707 2.78154 5.67933 12.8052 +9075 6 10.7376 26.5972 37.3568 -53.543 46.6204 -3.13137 +9076 4 10.2745 27.0143 38.1249 4.48347 -4.84659 -12.5134 +9077 4 11.4659 26.2171 37.7527 59.8403 -33.1666 26.4091 +9078 6 39.618 8.36935 32.0025 -18.1555 9.41152 20.5333 +9079 4 39.1948 8.91554 32.6893 14.8148 -9.04413 -3.7523 +9080 4 39.059 8.55692 31.2545 -3.75745 -0.899113 -17.0741 +9081 6 48.8678 24.2325 11.5968 8.56011 -30.9839 -7.0275 +9082 4 49.2355 23.3258 11.4382 -10.5357 21.2684 5.64902 +9083 4 49.6052 24.6956 12.0119 -1.11745 3.30341 0.0123828 +9084 6 15.7966 8.52145 22.5402 1.04041 9.04678 1.57429 +9085 4 15.9271 8.56462 21.5825 -0.708828 -3.15413 5.43528 +9086 4 15.5351 9.42629 22.7739 -0.982858 -3.13072 -0.606507 +9087 6 16.9647 23.5461 7.94634 -33.4976 4.63454 -7.56842 +9088 4 17.0449 23.8842 7.03772 17.2153 -3.19264 11.7182 +9089 4 17.7681 23.4723 8.45101 25.4501 5.7081 -7.03081 +9090 6 42.4788 26.856 6.32162 3.09129 16.6976 -8.96027 +9091 4 41.8509 27.5547 6.55233 4.05081 -5.7053 1.31186 +9092 4 43.1337 27.3683 5.79469 -5.76138 -9.42264 4.17624 +9093 6 36.7899 4.80361 30.039 -6.11534 9.52442 2.68488 +9094 4 37.0233 4.89717 30.9689 4.03122 4.23205 -0.240484 +9095 4 36.2783 4.00567 29.9694 -7.15291 -10.8132 -0.980928 +9096 6 45.6188 11.6101 3.31184 17.0103 13.4398 12.4748 +9097 4 45.8378 10.6807 3.43524 1.11174 -8.0511 2.33471 +9098 4 46.2756 12.0957 3.86714 -12.3909 -9.3108 -12.4209 +9099 6 24.8953 36.3829 21.2888 -10.2051 -4.79955 -3.81503 +9100 4 24.4947 36.4635 22.1668 10.8854 5.06826 1.45383 +9101 4 25.816 36.6689 21.3407 0.621807 2.11968 6.76072 +9102 6 31.8152 24.7333 2.44905 16.2387 18.0677 -0.666362 +9103 4 31.5926 23.846 2.71622 -2.49338 -12.6998 4.18613 +9104 4 32.794 24.7683 2.43834 -16.3068 -2.39725 -1.0987 +9105 6 24.1315 21.9864 37.2328 -11.9778 41.7246 15.7453 +9106 4 24.1531 22.9879 37.1682 1.73438 -35.6656 2.36813 +9107 4 24.6319 21.6756 36.4808 8.45953 -1.72708 -12.6617 +9108 6 37.1993 11.5451 15.0492 16.5469 7.10484 -0.527568 +9109 4 37.9299 11.7412 15.6355 19.6925 -10.3737 -3.43176 +9110 4 36.5282 11.9944 15.5291 -36.4248 10.8574 4.75341 +9111 6 36.4804 20.3298 41.7865 -14.7619 -38.0306 11.4639 +9112 4 36.2972 19.4996 41.306 -2.7681 3.32899 7.9346 +9113 4 36.9128 20.8369 41.1399 19.1888 26.5648 -23.5244 +9114 6 32.0378 37.9251 32.6621 -20.5074 -27.3147 -8.21436 +9115 4 32.5159 38.6908 32.9558 4.48721 20.2349 -0.22713 +9116 4 31.3298 38.1855 32.0457 8.6638 5.37323 8.26506 +9117 6 12.0353 39.9275 22.5179 -19.9222 21.97 13.043 +9118 4 12.3148 40.8142 22.1582 -9.65836 -22.9721 12.3921 +9119 4 11.2968 40.0749 23.1753 26.4497 -1.81786 -22.4595 +9120 6 26.3421 1.33641 19.2861 18.8224 -12.0939 15.9617 +9121 4 26.8564 0.711595 19.8557 -14.3211 16.2919 -14.6989 +9122 4 26.7977 2.18849 19.3545 -2.53714 -0.144297 -3.51109 +9123 6 5.91333 14.3058 5.68279 5.58536 -17.6781 -26.1831 +9124 4 6.35226 14.1008 4.80839 -10.2521 5.5819 21.3359 +9125 4 5.1498 13.7016 5.72209 7.95548 1.62414 0.442017 +9126 6 13.3681 23.0924 19.1542 -7.87238 10.4677 13.234 +9127 4 14.1204 22.8148 18.6592 15.6827 -8.39443 -13.4152 +9128 4 13.7622 23.5769 19.9007 -5.90355 -3.89356 -3.96922 +9129 6 23.3981 15.0775 9.7431 -16.2896 3.15659 0.0853289 +9130 4 22.5416 14.6758 9.94236 4.38356 -3.66538 1.71341 +9131 4 23.1926 15.7004 9.03099 5.43777 4.93098 -2.67512 +9132 6 49.5886 13.8369 18.4468 -1.57371 0.160736 10.1606 +9133 4 48.8725 13.4353 17.9701 -17.3578 -11.6866 0.338485 +9134 4 50.0711 14.2256 17.7358 20.2332 17.1818 -14.445 +9135 6 41.7455 5.66741 41.8995 19.0031 1.14603 7.86728 +9136 4 42.5946 5.93333 0.438032 -19.5636 -6.95293 -12.6597 +9137 4 41.9891 5.05837 41.1762 -2.65724 5.24908 4.18535 +9138 6 17.2511 35.5417 2.55548 5.2045 0.397579 1.12894 +9139 4 18.2067 35.619 2.48098 6.39755 9.05508 3.07921 +9140 4 17.0886 34.6316 2.34229 -4.27489 -11.2961 -3.02567 +9141 6 49.7041 19.8589 40.2412 43.8428 -27.8149 3.09893 +9142 4 49.318 19.0163 40.5437 -5.31641 8.5833 -2.14336 +9143 4 50.6864 19.6533 40.2493 -27.6084 12.6334 -3.24012 +9144 6 38.3071 5.82731 32.0534 -20.9946 -3.84451 12.3853 +9145 4 37.8352 6.48986 32.6009 6.6943 -7.79079 -6.23381 +9146 4 39.2094 6.1245 32.003 13.4939 6.60324 0.292563 +9147 6 16.2694 6.84865 34.0054 -5.49782 1.82896 8.85162 +9148 4 16.5828 6.71308 33.1028 9.77351 -3.29618 -0.21352 +9149 4 16.9894 6.61948 34.6288 -2.86373 0.259786 -9.19674 +9150 6 33.6805 18.2019 10.4544 40.2358 -26.4835 -11.4715 +9151 4 34.2537 18.8203 9.96489 -9.74865 -7.15313 7.53482 +9152 4 34.2179 17.3378 10.5117 -27.819 38.8859 -1.78852 +9153 6 38.8962 33.7675 36.7566 23.6769 3.34821 -39.6603 +9154 4 38.383 33.5793 35.9171 9.63189 4.7017 21.543 +9155 4 39.855 33.8637 36.4612 -29.1237 -5.01255 9.39617 +9156 6 45.367 13.0954 20.2202 -17.4715 7.54819 27.7127 +9157 4 45.262 12.6289 19.4029 4.78427 -8.6457 -19.3619 +9158 4 44.4728 13.0498 20.6095 8.33403 2.77458 -3.46579 +9159 6 36.394 32.2025 8.83838 -5.39961 -0.779561 10.8196 +9160 4 36.3766 31.4559 9.45045 4.37642 -0.919546 -0.394048 +9161 4 35.9671 32.9207 9.33542 2.20851 -0.984819 -7.57369 +9162 6 7.93081 27.8143 6.16526 -1.31132 8.47671 -18.7581 +9163 4 8.2701 27.2941 6.88743 5.87236 -5.84072 6.56369 +9164 4 8.18271 28.7096 6.41539 -7.71007 1.94397 -1.55613 +9165 6 14.2797 4.87717 33.6823 -38.1616 11.9775 -32.0892 +9166 4 13.6477 5.2447 32.9846 23.9092 -16.4836 27.177 +9167 4 14.8408 5.63056 33.8658 12.4601 7.15131 6.13949 +9168 6 12.2578 8.65243 9.85848 -4.82715 -2.24662 -5.48477 +9169 4 12.6456 8.73928 10.7118 23.7259 9.48722 19.5525 +9170 4 11.4378 8.2214 10.089 -13.622 -8.47682 -13.9839 +9171 6 29.7261 31.9842 8.54243 -17.2145 25.3825 -18.7463 +9172 4 30.1804 31.833 9.34913 11.7892 -12.8324 21.9258 +9173 4 29.6399 31.1708 8.03663 5.85846 -6.51984 4.51241 +9174 6 22.3891 10.8785 21.4662 8.73739 -5.18702 6.55753 +9175 4 21.8037 11.1386 20.7714 -14.2177 0.338512 -24.4291 +9176 4 22.2091 11.5521 22.1168 2.36988 5.22793 14.1218 +9177 6 54.1797 27.5396 12.9955 26.3988 -18.3584 17.6139 +9178 4 0.160041 27.5787 13.0909 -6.71045 -5.06664 4.99497 +9179 4 53.9798 28.2721 12.4475 -15.7222 27.4826 -22.0497 +9180 6 7.71973 13.812 20.0407 -34.9077 17.0186 -30.9147 +9181 4 8.32362 14.1503 20.6766 20.1403 8.526 22.156 +9182 4 7.35968 14.6399 19.6101 8.73645 -26.5601 8.16532 +9183 6 19.7932 0.841243 24.7869 -1.21084 18.2021 12.2367 +9184 4 19.1669 1.06895 25.5104 7.86649 -0.445713 -11.3386 +9185 4 20.4073 1.61074 24.7031 -15.4775 -18.2332 3.4978 +9186 6 3.01312 10.0986 2.94829 -27.2997 12.089 -8.88269 +9187 4 2.52802 10.9508 2.83041 12.1807 -20.5661 3.67701 +9188 4 3.91304 10.3154 3.17839 17.025 6.36995 4.07131 +9189 6 15.8857 13.0124 24.0049 15.5529 -4.67501 -5.43243 +9190 4 15.0856 13.5308 24.0834 -5.13718 6.9751 3.63726 +9191 4 16.3233 13.139 24.8614 0.105722 -2.17465 -3.852 +9192 6 17.0852 4.33969 26.9167 21.5143 -4.09641 1.48348 +9193 4 16.9912 4.27513 25.9666 -0.355278 1.74978 -10.9716 +9194 4 18.0601 4.31538 27.0472 -16.9044 3.21714 1.83131 +9195 6 33.6168 39.4091 10.6433 -2.74936 14.5855 -32.8438 +9196 4 33.9454 38.5625 10.8616 8.60753 -33.4012 17.9817 +9197 4 33.8375 39.4354 9.68976 -8.01757 16.2593 11.171 +9198 6 36.2326 1.10755 13.0941 -10.1125 -3.31802 -5.56412 +9199 4 35.6506 0.392496 13.3579 -10.7819 -8.26966 -9.36682 +9200 4 36.7599 1.20112 13.8707 17.1874 9.72194 12.3054 +9201 6 40.862 19.2925 5.11158 -0.402197 -15.9333 44.5432 +9202 4 40.3871 19.4968 4.34679 -15.032 12.6888 -52.1674 +9203 4 40.1189 19.1611 5.72143 13.4548 0.976419 10.4775 +9204 6 2.35452 37.5497 10.1778 32.5589 0.132829 19.8916 +9205 4 3.04634 37.0953 10.7141 -10.4583 9.64478 -9.40166 +9206 4 1.85979 36.8581 9.75685 -15.4906 -16.9123 -13.0897 +9207 6 8.10293 29.0334 15.8847 29.3895 -23.7333 0.542295 +9208 4 9.03551 28.6824 15.7668 -29.6945 17.5799 0.572456 +9209 4 8.18484 29.8326 16.4072 3.85606 5.10463 3.42896 +9210 6 47.3132 26.514 12.5427 4.56821 28.1849 -37.0073 +9211 4 47.5111 27.2634 11.8891 -8.56493 -28.9528 31.2783 +9212 4 47.3519 25.7475 11.9556 -1.34676 -3.33794 4.54904 +9213 6 33.5886 17.4994 0.666432 -7.15301 -2.01744 8.51284 +9214 4 32.6196 17.5968 0.930917 31.8637 -19.8727 -7.43903 +9215 4 33.9404 16.5735 0.747207 -21.2256 15.6146 2.50609 +9216 6 38.9757 15.6004 36.3686 4.31005 -11.6982 -11.4703 +9217 4 39.1719 14.652 36.4294 -3.02079 4.3409 1.02949 +9218 4 39.3764 15.8813 35.5317 -1.53099 5.14915 -0.246696 +9219 6 34.8198 34.351 9.37266 2.46578 -22.7668 -16.8875 +9220 4 35.3506 35.0289 8.96724 14.9634 11.0695 -15.2613 +9221 4 34.4558 34.8191 10.0913 -19.5236 18.4179 34.8179 +9222 6 44.9681 2.58102 14.7874 21.8703 21.498 2.75759 +9223 4 44.0383 2.44896 14.9383 -16.9502 -5.72583 1.77575 +9224 4 45.1679 3.47323 15.1264 -3.49788 -5.23458 -3.46791 +9225 6 42.6138 38.2902 19.8325 18.6047 12.1973 -29.2276 +9226 4 42.7029 39.1598 19.3445 -0.0117609 -27.8329 13.7468 +9227 4 43.0921 37.6383 19.2425 -13.1736 20.1758 17.0781 +9228 6 18.6869 26.7647 30.2619 -33.6624 -6.012 -17.6355 +9229 4 18.1258 26.7596 29.445 14.3051 -0.674317 21.614 +9230 4 19.5687 26.9499 29.9621 19.5047 4.84041 -5.57389 +9231 6 38.8661 37.7421 16.4836 -9.78438 -6.51051 7.80135 +9232 4 38.7478 36.8102 16.2377 -7.01003 6.44463 1.75037 +9233 4 39.8105 37.8446 16.5724 18.1337 5.4462 2.51551 +9234 6 49.3017 9.82081 12.5377 12.9664 18.8416 30.0962 +9235 4 48.8085 9.39111 11.8826 -17.6666 -23.7062 -38.8329 +9236 4 48.5984 10.2345 13.0427 4.42646 9.01279 7.79627 +9237 6 43.2246 7.36268 19.8264 -1.99344 11.167 24.993 +9238 4 42.5572 7.81175 20.4051 12.7818 -10.9207 -14.0727 +9239 4 44.1025 7.51179 20.2375 -5.96789 -3.6213 -7.06723 +9240 6 36.3461 38.714 4.42821 -2.77728 9.11116 8.98737 +9241 4 36.8002 39.5234 4.70824 5.05063 -6.10698 -1.49424 +9242 4 35.4394 38.9016 4.68929 -3.84434 -7.68842 -3.54296 +9243 6 27.8 17.802 15.105 0.992317 -7.44098 -8.78046 +9244 4 27.5393 16.935 14.729 3.58787 16.6938 2.50389 +9245 4 27.8517 17.6781 16.0585 0.147204 -0.130556 3.13955 +9246 6 18.0837 3.77506 37.3201 -10.3169 -12.5791 -10.2966 +9247 4 18.6663 3.07474 37.0146 -2.03685 -5.25132 -4.70316 +9248 4 18.6637 4.19691 37.9324 10.4473 20.1285 21.3871 +9249 6 7.71395 11.575 6.52222 6.59834 -21.2687 20.1659 +9250 4 7.75955 12.4254 6.93969 -0.705235 13.257 9.50392 +9251 4 7.66936 11.739 5.5978 -3.42683 1.36071 -31.338 +9252 6 31.4909 14.3449 18.0451 -1.46982 -12.276 17.176 +9253 4 32.1287 14.6507 17.397 7.38292 5.65775 -7.44504 +9254 4 32.0331 13.8785 18.7146 -6.90734 4.25576 -5.30331 +9255 6 50.3346 30.4143 8.91505 10.1635 2.25064 -1.90936 +9256 4 49.6557 30.853 8.39615 -4.47176 4.28708 -1.87566 +9257 4 50.0231 29.531 9.11356 -2.73977 -1.84009 2.34474 +9258 6 42.1686 10.1057 12.759 16.2008 2.03437 -4.20809 +9259 4 41.2649 9.83209 12.6487 -17.4225 -8.81494 -4.74081 +9260 4 42.1292 10.8861 13.3105 -1.28453 5.18814 5.66853 +9261 6 37.773 3.09539 32.5582 -5.24906 4.78867 -2.39206 +9262 4 38.0736 3.99724 32.5969 21.7942 11.3719 -4.3192 +9263 4 36.8519 3.25822 32.7463 -19.4678 -11.9252 3.55114 +9264 6 35.7586 13.1005 19.2721 9.99017 -22.7528 0.0781354 +9265 4 36.1308 13.8223 19.7887 2.26592 2.2719 5.61144 +9266 4 36.2509 12.2915 19.5517 -9.66412 15.3645 -2.5809 +9267 6 45.5318 4.12684 21.4944 7.1153 -16.224 0.922187 +9268 4 45.5588 4.23252 20.5315 -1.8039 6.94223 3.67507 +9269 4 45.7548 3.18328 21.6122 -5.15542 13.2346 -0.821742 +9270 6 16.876 1.8608 31.4782 -3.84426 -17.9183 -35.0426 +9271 4 16.0621 2.17388 31.0004 15.6258 0.929179 27.3362 +9272 4 17.1381 2.25043 32.3174 -12.6393 14.1325 4.42374 +9273 6 14.0947 4.88307 23.5769 -10.6061 -28.6131 16.0669 +9274 4 13.8059 5.76888 23.7237 -2.25817 32.588 -6.82267 +9275 4 13.6039 4.42137 24.2892 9.04813 -2.88937 -11.9208 +9276 6 38.3208 33.7635 12.3625 -16.3318 -7.70706 -26.0192 +9277 4 38.1373 32.9408 11.8506 0.297782 14.7405 12.2413 +9278 4 39.1486 33.6221 12.8093 16.0136 -1.39994 11.7584 +9279 6 35.6849 3.05753 37.6719 3.72695 1.1389 -16.7638 +9280 4 35.1101 2.5063 38.212 -4.0587 0.687226 6.19097 +9281 4 35.8854 3.87289 38.1447 -1.86413 5.08658 8.8135 +9282 6 31.3385 37.395 35.3723 -12.2239 -8.91609 34.0312 +9283 4 32.2231 37.7249 35.5382 9.93962 6.70229 -3.55138 +9284 4 31.225 37.4524 34.4409 4.86335 0.993516 -31.3389 +9285 6 52.0614 11.7324 14.0182 20.1458 -4.7001 -39.6215 +9286 4 52.0268 11.0667 13.2735 0.495691 14.4049 24.809 +9287 4 52.7095 12.4171 13.7023 -24.8081 -17.2766 13.6147 +9288 6 26.3478 3.42613 41.0189 1.80794 1.58056 -19.374 +9289 4 25.6151 4.01507 40.9203 -25.7718 5.99951 16.8165 +9290 4 26.7914 3.68675 40.2055 22.5797 -12.3384 -0.204994 +9291 6 24.3802 34.9453 11.1613 28.8325 38.7039 -6.19962 +9292 4 24.3515 34.6784 12.0652 -4.50215 -14.1529 28.2178 +9293 4 23.9023 34.3202 10.6558 -20.492 -31.6724 -14.1682 +9294 6 32.0094 7.59293 31.2147 -3.26399 8.81733 5.62682 +9295 4 32.0976 7.47613 30.2777 2.1706 -0.778595 -17.1478 +9296 4 31.5266 8.43606 31.2858 0.565291 -7.84955 4.65821 +9297 6 28.7282 2.60805 0.424377 -15.1279 1.50585 -5.39222 +9298 4 29.2952 2.36387 41.5859 -5.33248 3.35197 5.42737 +9299 4 27.7901 2.65331 0.119401 23.4632 0.0509354 2.06419 +9300 6 42.125 19.2126 9.86039 10.7783 -7.26578 33.4177 +9301 4 42.6695 19.2101 10.7019 -20.1092 0.869002 -30.5597 +9302 4 41.4363 18.5278 9.96356 3.48727 6.10561 -4.25932 +9303 6 33.0194 27.0842 8.32851 16.6372 -6.55357 -10.7525 +9304 4 33.8911 27.0001 7.90493 -7.38323 -0.765342 -2.5624 +9305 4 33.2437 27.3744 9.20899 -0.425855 7.33259 11.2137 +9306 6 4.16433 8.30018 19.1575 16.0783 -2.51395 5.95143 +9307 4 4.71165 7.98099 18.3991 -19.3854 5.29846 8.38252 +9308 4 3.22273 8.32359 18.9288 3.05712 -5.28108 -12.2975 +9309 6 20.7745 29.1912 37.0609 -25.9123 -20.3491 -5.83769 +9310 4 21.0713 28.277 37.0594 -15.1664 -12.7508 0.5123 +9311 4 21.6013 29.5933 37.1743 32.957 35.4267 8.73191 +9312 6 13.1089 4.99809 10.9103 2.80775 13.1965 -7.17841 +9313 4 13.4591 5.85092 11.2415 -2.5949 -14.1267 -1.88178 +9314 4 12.7051 5.16456 10.0462 -1.2434 3.82389 2.90473 +9315 6 37.5087 18.1031 32.5343 20.0502 31.699 14.1692 +9316 4 38.1018 18.8164 32.1735 -18.2411 -21.7333 4.56216 +9317 4 37.2041 18.4813 33.3903 1.90105 -7.17599 -12.7275 +9318 6 17.7655 33.2839 30.7231 12.9967 19.9173 -17.9311 +9319 4 17.8488 34.0437 30.1253 -3.68331 -4.50715 1.49576 +9320 4 18.5638 33.345 31.2563 4.57995 -0.934488 4.72964 +9321 6 23.1969 32.7832 9.90135 2.14033 10.4984 -5.43395 +9322 4 23.4737 31.9362 10.2634 3.28964 -4.66398 1.33779 +9323 4 22.2469 32.7196 9.72631 0.753558 0.42269 -0.434072 +9324 6 14.8911 9.35828 34.246 -8.54616 0.784134 0.501674 +9325 4 15.4672 8.59016 34.1372 5.2294 -0.0873347 -3.8795 +9326 4 15.23 10.0905 33.7027 2.53244 -1.05206 0.202563 +9327 6 31.1203 39.3599 38.5719 4.30147 -17.578 8.21172 +9328 4 31.5941 38.6377 39.0527 -10.1026 17.4492 -9.05875 +9329 4 30.4019 38.9077 38.1077 1.84332 2.82409 1.03593 +9330 6 5.29005 34.4279 28.2716 -0.764315 -10.945 -9.90403 +9331 4 5.24266 35.3772 28.447 -0.427568 -2.02335 -2.15628 +9332 4 5.18384 34.3192 27.3143 2.05225 4.04935 9.99949 +9333 6 30.3216 21.6974 14.1256 3.24994 1.03129 -0.468005 +9334 4 30.4656 20.7696 14.235 0.884625 -14.9253 16.053 +9335 4 30.3519 21.7638 13.1772 -0.963709 16.3006 -15.7103 +9336 6 23.8542 39.0018 28.2919 38.6077 23.8437 -8.99828 +9337 4 23.8505 39.6937 27.6143 9.44649 3.56781 3.51793 +9338 4 23.0185 38.6309 28.1896 -50.029 -28.3524 0.952356 +9339 6 9.61332 13.5451 16.4567 13.7131 10.5156 -25.323 +9340 4 8.77595 13.0917 16.3907 -9.93448 -5.52821 8.41851 +9341 4 9.74204 13.8378 15.5322 5.69689 -3.544 12.5309 +9342 6 25.9753 6.18174 15.7989 23.4837 -9.67411 23.9067 +9343 4 26.0218 6.10484 14.8454 5.11216 -1.95092 -7.71856 +9344 4 26.7445 5.66727 16.1761 -27.6477 18.1551 -17.3833 +9345 6 15.9921 33.6419 22.5616 2.25497 8.86036 -26.9911 +9346 4 16.0049 34.0594 21.6804 -4.22455 0.568633 15.0409 +9347 4 16.1032 32.7157 22.281 -1.05219 8.42244 16.6761 +9348 6 40.6812 13.5416 12.1266 -4.5396 -12.3661 6.74099 +9349 4 40.4134 12.947 11.4149 -4.75912 -2.4644 -8.17888 +9350 4 41.058 12.9332 12.7776 -0.386087 8.79442 1.8157 +9351 6 35.5875 40.2809 31.6993 12.2791 -13.6127 -29.8257 +9352 4 35.948 40.913 31.0681 -4.17713 12.2213 7.17402 +9353 4 35.6271 39.4709 31.1475 -9.59473 3.36029 20.1077 +9354 6 19.3493 17.5927 17.849 24.123 48.8902 3.26857 +9355 4 19.9577 18.423 17.9915 -34.5112 -38.8316 -9.06029 +9356 4 18.6928 17.806 17.1645 6.15508 1.01267 5.31501 +9357 6 7.96541 28.082 10.7737 20.0283 17.3944 8.50509 +9358 4 8.43659 28.8341 11.2297 -13.1431 -15.7733 -11.3814 +9359 4 7.20109 28.4458 10.3015 -0.215648 4.06143 0.688545 +9360 6 32.1489 39.5869 16.6475 -7.37335 1.81146 -4.92627 +9361 4 31.705 40.4043 16.3332 3.90743 -15.5774 4.53996 +9362 4 31.4977 38.8659 16.5723 3.01217 10.596 3.08762 +9363 6 35.8095 2.63602 18.127 2.07542 -14.8225 4.13142 +9364 4 34.8947 2.32962 18.1713 7.15775 -3.6283 3.09768 +9365 4 35.7135 3.4873 17.7367 2.81673 20.5762 -11.5045 +9366 6 14.9588 39.9585 36.8943 -2.86001 -28.3727 24.0409 +9367 4 15.4545 39.4909 36.2335 10.0689 -8.68258 -13.459 +9368 4 15.0094 40.8569 36.655 2.72867 44.443 -9.08423 +9369 6 18.3115 32.3916 11.4639 8.59274 12.4423 14.7113 +9370 4 18.6438 32.5881 12.3772 -9.2478 -5.5834 -23.9484 +9371 4 17.8762 33.212 11.1576 6.35145 -13.5457 0.164794 +9372 6 14.605 10.3819 4.99774 5.57597 -6.68493 12.6773 +9373 4 13.677 10.4388 4.75284 -6.10435 1.24571 -3.75468 +9374 4 14.6185 10.047 5.91478 4.2493 4.0336 -10.9734 +9375 6 2.02851 14.3408 39.1627 -4.03313 12.5981 -1.48522 +9376 4 2.74992 15.009 39.2086 -14.5088 -8.45155 5.07373 +9377 4 1.21458 14.679 39.6124 19.1623 -3.42757 -8.41789 +9378 6 7.58709 14.1522 32.4651 10.4977 19.6861 -0.504887 +9379 4 6.93593 13.6605 32.9674 -3.57672 2.30039 3.8359 +9380 4 7.5987 15.0834 32.797 -1.90079 -22.9019 -5.87851 +9381 6 6.15309 23.123 37.664 -26.7168 -14.8188 -11.2926 +9382 4 6.52639 23.9838 37.7378 17.5333 20.6862 9.20416 +9383 4 5.45539 23.2608 36.9958 8.40974 -10.7335 8.81374 +9384 6 37.3009 22.5422 4.44282 21.6187 66.9857 0.670839 +9385 4 36.5208 22.1217 4.15693 -30.5217 -23.5005 -12.8181 +9386 4 37.1232 23.5227 4.23696 10.5274 -41.8214 11.62 +9387 6 47.1349 31.0113 5.88613 -14.3653 5.64202 -58.02 +9388 4 46.9542 30.9019 6.7933 -9.29323 -2.10558 39.1512 +9389 4 46.2627 31.2059 5.44524 20.5013 -7.22248 10.5418 +9390 6 54.8094 25.5909 34.9286 -5.37395 41.5808 12.672 +9391 4 54.0266 25.5089 35.4943 -0.981006 -11.4098 -6.26775 +9392 4 0.0616925 26.543 35.1263 -1.5494 -32.4448 -11.2369 +9393 6 37.1551 2.08197 4.79239 -12.5712 23.0197 -22.5278 +9394 4 36.5844 2.86136 4.61445 9.59981 -14.8952 -2.62483 +9395 4 37.0798 1.96202 5.72873 2.5296 -7.23911 19.6989 +9396 6 22.5239 28.6012 8.91155 -7.98869 19.6075 21.4366 +9397 4 22.8946 28.4124 9.79991 -0.853296 -5.89568 -17.4096 +9398 4 22.801 27.9767 8.25343 10.1708 -14.6558 -3.7409 +9399 6 8.64208 27.1509 24.5664 -38.2161 25.5543 4.78276 +9400 4 7.71753 26.8887 24.5582 -5.16372 11.0804 -0.386298 +9401 4 9.04357 26.3309 24.4724 40.7169 -47.477 -5.23592 +9402 6 1.14997 23.727 2.4309 6.46058 8.65979 -14.8341 +9403 4 1.18232 23.9936 1.48373 -6.63581 -4.99587 16.5657 +9404 4 0.310199 23.2733 2.54924 -0.981545 -0.950126 -1.89037 +9405 6 54.3702 30.2259 27.0243 -0.035121 6.58363 -4.50453 +9406 4 54.2615 29.4654 26.4339 1.23903 8.74071 -4.24792 +9407 4 54.6064 30.9974 26.4582 -3.83852 -12.4126 5.30421 +9408 6 0.386829 8.42023 23.9938 5.00922 -16.8445 -6.80376 +9409 4 1.36083 8.4508 24.0758 -8.17173 1.21512 3.08891 +9410 4 54.9524 8.88826 24.7258 9.13745 3.54566 6.13736 +9411 6 16.8971 28.5839 33.3722 23.8511 -30.9569 -4.46587 +9412 4 17.442 28.7831 34.1436 -6.82268 9.96305 3.46007 +9413 4 17.4403 27.8723 32.949 -23.4552 19.8179 6.40974 +9414 6 33.6969 30.8931 0.141175 14.1795 0.777253 -0.635822 +9415 4 34.6278 30.5945 0.162696 -6.8513 6.78484 1.91826 +9416 4 33.3211 30.3583 41.3463 -2.66034 -4.05802 -0.0970656 +9417 6 16.2525 21.5202 34.1552 3.2099 -15.0674 -0.387853 +9418 4 16.0099 20.7546 33.5903 4.90739 13.2878 5.87792 +9419 4 16.6977 21.1376 34.9376 -8.96682 7.2262 -10.6242 +9420 6 0.22977 17.7868 35.7492 -9.57638 -14.7124 1.37696 +9421 4 54.2434 17.9569 35.6827 28.6901 -4.22084 5.11773 +9422 4 0.351694 16.93 36.209 -4.1051 13.1178 -5.65765 +9423 6 16.8289 12.2962 0.019427 11.8958 12.8939 11.6481 +9424 4 17.3016 12.8498 0.703368 -12.3262 -21.137 -14.7379 +9425 4 16.4403 11.4936 0.411486 1.39397 8.07719 2.11333 +9426 6 8.24246 9.54397 36.2629 -25.8472 21.2414 2.40819 +9427 4 7.81464 8.9356 36.8788 1.26461 -2.06425 2.56422 +9428 4 7.48979 10.0869 35.9067 16.4576 -8.29365 1.86334 +9429 6 48.5761 26.718 39.8382 -16.8767 -13.2223 25.9758 +9430 4 48.2189 26.9037 38.9774 0.202946 6.43929 -15.4249 +9431 4 49.4865 26.9849 39.8847 17.129 6.93076 -9.10183 +9432 6 35.4777 1.07865 23.1156 20.3084 9.46551 28.8556 +9433 4 36.0215 1.72656 22.6213 -7.75205 -10.5654 8.45632 +9434 4 35.804 1.12911 24.09 -10.3378 -1.68949 -45.1242 +9435 6 20.2777 30.6326 19.3782 17.168 -16.4055 9.77372 +9436 4 20.2499 31.0311 20.2788 1.56461 -6.55175 -10.0354 +9437 4 20.938 29.881 19.3855 -20.6701 22.3694 2.2449 +9438 6 44.3702 15.9458 1.58361 10.9348 22.193 31.2112 +9439 4 44.4077 15.6379 2.51116 -1.71559 -1.42871 -18.164 +9440 4 44.6431 16.8967 1.66823 -9.97295 -22.8516 -13.6111 +9441 6 53.8845 34.4651 10.6068 -24.0145 7.95167 -19.3224 +9442 4 54.4361 34.2696 11.3314 22.7066 -9.19703 33.7305 +9443 4 54.2985 35.2035 10.1555 0.2437 -1.83103 1.50375 +9444 6 46.1364 32.8471 33.519 4.96533 -12.2334 2.48444 +9445 4 45.9404 33.6629 33.0556 -3.66306 8.73713 -2.86335 +9446 4 47.0477 32.6179 33.2654 -4.26196 1.19291 1.09329 +9447 6 42.1324 21.9098 24.2239 34.4777 -24.9191 34.4505 +9448 4 43.0412 21.5159 24.3646 -28.4667 14.3091 -11.1056 +9449 4 41.7437 21.6811 25.0949 -3.80951 9.2794 -19.6729 +9450 6 8.14185 3.89847 11.6387 2.30661 -15.3192 6.95264 +9451 4 7.35197 4.1174 12.1322 -8.99547 12.8437 -2.29886 +9452 4 8.35392 3.05748 12.0535 10.9023 -1.5691 -3.31016 +9453 6 19.6413 41.6808 9.8267 1.07442 6.29255 0.337359 +9454 4 18.9204 41.094 9.57509 0.414049 2.67892 1.92063 +9455 4 19.352 0.205183 10.6506 0.427822 -12.2572 -10.0953 +9456 6 42.3157 8.41085 31.6785 13.3628 11.5473 -7.23952 +9457 4 41.3969 8.42848 31.9417 -9.73605 -1.80426 0.915182 +9458 4 42.5534 9.35818 31.5624 -0.333442 -16.319 1.99913 +9459 6 26.911 16.154 25.3637 -0.10907 13.2502 -20.6653 +9460 4 26.7939 15.8861 24.4207 -0.565005 2.37017 21.4763 +9461 4 26.6835 15.4121 25.9182 -3.52016 -12.4926 6.14171 +9462 6 48.2345 6.48613 12.6212 -1.55264 -8.09911 -9.8466 +9463 4 48.9652 6.31914 12.0011 -5.93235 3.28214 2.19301 +9464 4 47.4516 6.10442 12.1764 7.36669 2.93589 5.65527 +9465 6 53.4556 41.5274 30.6561 0.928349 -3.66285 -10.4005 +9466 4 53.9738 41.8466 29.9077 -1.68735 -3.84443 -4.80087 +9467 4 53.7246 0.16796 31.3785 5.2081 5.34012 15.7103 +9468 6 47.0719 22.4215 31.8177 3.79963 28.0651 -15.4962 +9469 4 47.8542 22.5824 31.2379 -15.4047 -7.22606 14.7582 +9470 4 46.5391 23.2393 31.6689 5.43499 -22.2824 10.2038 +9471 6 19.5241 5.44646 15.2431 57.7261 9.00726 -25.1025 +9472 4 19.973 4.5781 15.2547 -6.4602 7.66804 1.10752 +9473 4 18.6769 5.33307 15.596 -47.9766 -8.78418 19.1468 +9474 6 14.6808 30.2445 33.392 16.954 11.9814 -17.0239 +9475 4 15.1668 30.8865 32.8123 -10.4914 -16.0898 10.6301 +9476 4 15.2553 29.4559 33.3904 -4.22445 9.80292 -0.52553 +9477 6 28.4427 24.2289 10.4187 -0.774793 -27.6212 -36.8967 +9478 4 29.277 24.4414 10.8128 10.21 14.4589 20.8069 +9479 4 27.7162 24.5027 10.9517 -9.91177 12.6254 22.5109 +9480 6 5.25429 14.4357 24.4952 18.8694 8.38265 -3.5804 +9481 4 4.38598 14.1455 24.6681 -43.369 -9.18674 12.4123 +9482 4 5.45154 13.9758 23.6794 9.52503 -2.95522 -10.1363 +9483 6 26.3476 19.2988 19.1857 11.4015 -18.2951 -12.5804 +9484 4 26.5417 20.1869 19.4853 3.52858 10.6793 1.31948 +9485 4 27.146 18.9308 18.7141 -21.2465 13.7562 17.259 +9486 6 28.5834 7.44603 13.1845 8.68409 29.8386 11.3246 +9487 4 28.3961 6.55455 12.9442 -2.45324 -19.0833 -9.20205 +9488 4 29.0571 7.89665 12.4686 -5.14786 -6.54739 -1.73865 +9489 6 5.35742 27.1473 37.0464 13.0843 -4.728 13.8292 +9490 4 6.09472 26.8663 37.6487 -17.7636 2.66278 -18.049 +9491 4 5.49884 28.0724 36.7882 1.93418 -3.90879 0.386893 +9492 6 53.1466 13.4128 16.1104 33.6732 -23.607 0.886679 +9493 4 54.0532 13.0537 15.8959 -24.4904 18.1541 2.55443 +9494 4 52.6056 12.6236 16.2807 -0.490038 10.6025 -2.0621 +9495 6 45.4595 1.03561 24.6152 0.883869 7.22473 8.82703 +9496 4 44.8005 0.912307 23.9218 -0.0838502 -1.3445 -1.23214 +9497 4 44.9845 0.757767 25.4168 6.19386 0.932014 -5.94613 +9498 6 50.1542 2.38642 13.9319 -2.4774 12.931 -1.3926 +9499 4 50.7815 2.76975 13.3044 0.014285 -4.08681 1.38242 +9500 4 49.5062 3.09016 14.0651 -1.63783 -0.639647 1.83323 +9501 6 19.5885 31.0175 39.1657 -10.9837 -21.6636 -18.6241 +9502 4 19.8079 30.3148 38.4832 -5.60324 21.7545 20.6111 +9503 4 18.6148 30.9453 39.3442 26.0441 2.6939 -5.02925 +9504 6 19.2491 14.7106 10.8907 20.9533 -11.5465 -13.087 +9505 4 20.0062 14.1954 10.4207 -44.2836 18.7066 28.5885 +9506 4 18.7045 14.0688 11.3882 14.1221 2.37282 -8.47947 +9507 6 4.44986 39.5549 20.1348 -7.46971 20.8744 22.4052 +9508 4 3.99116 40.4291 20.2667 12.3042 -22.0468 -4.08326 +9509 4 4.78876 39.261 21.0122 -11.398 5.88582 -21.7205 +9510 6 29.0264 13.3645 23.891 3.80322 20.0192 21.3715 +9511 4 28.7263 12.4558 23.8574 1.87437 -3.97007 -2.19356 +9512 4 28.9189 13.5991 24.8488 7.01015 0.856522 -27.3099 +9513 6 17.0674 2.76528 17.6511 13.6679 -9.88609 -24.0062 +9514 4 16.9089 3.43106 16.9566 -0.337692 -4.66999 2.92783 +9515 4 17.7694 2.16287 17.2836 -16.7881 13.7863 9.44417 +9516 6 43.472 18.0456 17.7207 2.90116 -6.00314 -10.3001 +9517 4 43.5328 17.0661 17.6262 0.602958 19.7978 9.46789 +9518 4 43.5843 18.2505 18.6627 0.176297 -8.32564 -1.3476 +9519 6 25.7838 40.7303 1.24723 -3.64329 26.5644 -28.0564 +9520 4 26.2198 41.3001 1.88369 1.46132 -2.86659 8.1156 +9521 4 25.5777 41.3986 0.532216 -2.57635 -28.6607 13.7824 +9522 6 0.458758 22.8928 6.22327 -2.28892 -3.37321 -2.62932 +9523 4 0.911995 22.0955 5.88137 -3.49653 6.37629 4.11618 +9524 4 1.15027 23.4262 6.63616 1.38998 -0.611711 -3.15133 +9525 6 26.2502 35.0072 18.629 11.2346 5.37396 -16.6635 +9526 4 25.9102 35.926 18.5821 -1.77201 -16.2127 4.61622 +9527 4 25.7094 34.5197 19.2578 -0.594129 4.22999 1.61862 +9528 6 16.1509 31.8837 7.54876 40.1408 -29.5169 -1.86921 +9529 4 16.9528 31.2446 7.38162 -38.5191 36.6879 6.5811 +9530 4 16.2422 32.6162 6.9246 8.25996 -4.45471 -3.71716 +9531 6 22.9569 16.8424 28.5503 -18.0144 15.9011 -12.9281 +9532 4 23.0242 16.0615 27.9964 2.65193 -8.47258 -0.731728 +9533 4 22.0914 17.2685 28.2981 23.9965 -14.5366 15.8079 +9534 6 48.817 29.3453 32.1483 10.2159 -3.67765 25.2301 +9535 4 47.913 29.23 31.8533 -10.4354 1.38436 -5.08298 +9536 4 48.8482 28.9579 33.0615 0.343667 8.53482 -20.1614 +9537 6 13.1275 24.857 5.54597 -15.7655 12.0094 -10.6158 +9538 4 12.8967 24.1126 4.95892 -3.19147 7.26676 2.83523 +9539 4 12.4206 25.5605 5.45199 17.9822 -22.1189 1.55356 +9540 6 10.967 20.7149 15.8389 3.49035 -8.57129 -4.90872 +9541 4 10.8232 20.5385 14.8814 6.84933 2.21154 19.4522 +9542 4 11.8211 20.2878 16.0966 -18.2767 7.30584 -13.8769 +9543 6 13.8574 18.376 6.9425 -18.5688 18.5302 -26.9748 +9544 4 14.0551 19.3329 6.99178 3.58444 -10.9562 5.12073 +9545 4 14.2751 17.8929 7.64202 12.8225 -6.30863 19.0643 +9546 6 13.8485 12.9413 30.6405 -7.33075 -24.1801 -9.47477 +9547 4 13.9233 12.3923 29.8469 14.5901 9.31788 -1.12157 +9548 4 13.0284 12.552 30.9634 -3.13873 11.8242 15.1361 +9549 6 17.1199 6.33729 31.2705 58.4108 60.4292 21.9502 +9550 4 16.7347 7.19592 31.0485 -2.55536 -2.82538 -1.05014 +9551 4 16.4932 5.72664 31.0455 -61.4006 -55.6776 -22.0804 +9552 6 7.63858 23.4232 20.5528 2.70849 -2.51933 -11.6338 +9553 4 7.34936 23.0623 19.6936 2.42656 1.66026 8.60009 +9554 4 8.06294 24.2698 20.3247 -2.54411 -7.58863 2.30144 +9555 6 15.6012 36.6828 25.6308 12.0382 0.865576 2.42327 +9556 4 16.546 36.4866 25.8589 -19.7129 13.5166 -7.57965 +9557 4 15.5566 37.5233 25.1245 15.7859 -9.47529 6.9914 +9558 6 0.738662 10.4099 22.1708 -26.6289 -22.4058 -14.7131 +9559 4 0.0268398 10.3645 21.4686 20.8647 0.21224 20.3485 +9560 4 0.555589 9.63254 22.7491 3.84168 18.0907 -12.5939 +9561 6 33.5034 17.3959 33.5951 21.201 30.6084 -13.4811 +9562 4 33.5895 18.3893 33.3705 0.776259 -45.1899 5.95193 +9563 4 34.1847 16.8766 33.1005 -9.04546 14.4589 8.38708 +9564 6 21.6622 19.013 20.7578 31.9274 -22.1518 -4.15649 +9565 4 22.4096 19.6032 20.9777 -11.5486 -3.71871 -1.82252 +9566 4 22.1307 18.1402 20.6082 -20.9219 25.304 3.1187 +9567 6 41.7583 19.992 16.8792 -6.68772 4.02339 -8.69865 +9568 4 42.2438 19.1637 16.9575 3.64207 -5.49479 0.617993 +9569 4 41.579 20.1273 15.9247 3.71595 -2.33609 11.0843 +9570 6 12.0355 14.9654 17.6922 -21.5841 1.26502 -18.8824 +9571 4 11.2182 14.5976 17.276 14.8021 5.3277 12.4216 +9572 4 12.4319 14.255 18.1907 -0.352973 -10.2116 7.98966 +9573 6 23.0172 11.4191 40.7206 -10.7217 24.0381 44.0704 +9574 4 22.9528 12.3236 41.1181 -0.480688 -24.3492 -4.33206 +9575 4 23.3445 11.5906 39.8675 15.3819 0.516123 -37.823 +9576 6 21.0055 28.3299 24.5595 -23.1154 26.0001 -7.02903 +9577 4 20.2855 28.1767 25.1713 -12.8069 16.7504 -3.2857 +9578 4 21.5564 27.6405 24.838 35.6802 -30.9994 4.41974 +9579 6 19.406 13.705 31.9364 14.5236 -8.57279 10.3452 +9580 4 18.7521 13.9469 31.2876 -5.81883 0.611034 -8.78432 +9581 4 18.9142 13.6788 32.7621 -0.186305 1.04404 6.29106 +9582 6 21.5918 2.86134 24.7058 -12.3779 12.1824 -8.79066 +9583 4 21.7274 3.16074 23.7816 9.4572 -7.89437 13.7797 +9584 4 22.4025 2.45534 25.0386 5.22934 2.42127 -4.70961 +9585 6 11.3487 29.9838 18.827 10.5554 -3.16976 4.47537 +9586 4 10.5352 30.5203 18.751 15.2364 -2.61973 2.60085 +9587 4 12.0043 30.4181 19.4217 -22.0541 -6.82347 -15.9561 +9588 6 14.6417 22.3529 8.3686 35.183 35.1516 7.4005 +9589 4 14.0314 23.0645 8.61446 -9.87113 -8.59651 0.991548 +9590 4 15.5117 22.8693 8.31218 -34.203 -30.7208 1.23805 +9591 6 43.9533 23.6664 17.2647 -9.15762 31.6597 -10.4885 +9592 4 44.7744 23.2846 16.9678 11.7125 -13.1472 -3.62648 +9593 4 43.5104 22.9908 17.7726 1.91474 -8.51607 6.21827 +9594 6 28.003 25.5014 27.4986 6.23457 -29.1533 -5.23677 +9595 4 27.4849 26.2827 27.5489 -17.6876 27.9136 1.36856 +9596 4 28.906 25.8001 27.3829 8.21911 6.89622 0.0845564 +9597 6 19.1046 26.8047 33.1413 12.2661 11.24 -48.0243 +9598 4 19.0365 26.4782 32.1917 1.11076 11.999 35.7369 +9599 4 19.4769 27.7251 33.0545 -9.7287 -23.6705 8.34301 +9600 6 6.37289 19.3428 5.67363 -3.21133 -16.2285 8.07537 +9601 4 6.7336 20.019 5.09886 3.22925 8.22387 -6.14542 +9602 4 5.58923 19.7346 6.08082 -0.796808 3.74051 2.3056 +9603 6 37.4835 28.3972 9.67963 -16.8252 8.64443 -22.9196 +9604 4 37.8384 28.0931 10.5154 1.79485 -10.7977 1.13655 +9605 4 37.3056 27.6421 9.07717 9.05958 5.47813 21.4583 +9606 6 17.6994 27.086 11.7957 -23.9049 -9.71644 -0.114793 +9607 4 16.9894 26.5877 11.2784 19.3807 18.9653 23.0761 +9608 4 17.3772 27.2467 12.7205 1.32974 -4.86863 -22.184 +9609 6 12.8804 1.95044 24.1635 -16.9081 23.6463 -41.3936 +9610 4 12.0123 2.42693 23.9788 24.6345 -20.1638 18.4271 +9611 4 12.9602 1.63912 25.0531 -11.2641 -4.9093 21.6908 +9612 6 27.8486 37.1249 33.3037 14.5525 0.843809 -12.8082 +9613 4 27.8306 37.7566 32.5563 -0.261378 -9.54721 11.1245 +9614 4 28.4641 36.389 33.0416 -14.495 18.5162 4.94281 +9615 6 18.6769 12.3657 6.31954 -0.243732 -29.9473 12.6257 +9616 4 18.5317 11.3932 6.23771 0.963018 17.4883 6.62231 +9617 4 18.5535 12.6707 5.42951 -3.51714 10.9469 -19.8301 +9618 6 10.1845 29.3127 24.783 -1.36331 5.89889 -4.08473 +9619 4 10.7465 29.1085 25.5662 -10.353 -5.60455 -9.55427 +9620 4 9.5047 28.6152 24.6271 17.6265 9.93184 12.3415 +9621 6 7.25219 3.30976 16.2618 16.5712 6.01323 38.0962 +9622 4 7.85224 3.92676 16.743 -7.28275 2.21025 -21.7569 +9623 4 7.07626 2.67339 16.9792 -0.839688 -3.96601 -21.0406 +9624 6 32.2032 37.556 1.10106 -1.45173 2.30566 -1.67736 +9625 4 31.7319 37.0242 1.72254 -12.3544 -30.6614 1.12887 +9626 4 32.1826 38.3533 1.61216 9.84976 31.1212 -1.90535 +9627 6 10.4132 10.1536 6.41547 2.6172 -5.66149 -5.23088 +9628 4 9.51094 10.4988 6.43252 -1.43241 7.72691 5.99088 +9629 4 10.888 10.4598 7.20926 -10.4429 3.02901 -4.20627 +9630 6 16.1922 23.2473 37.3836 13.4596 17.9231 -6.20094 +9631 4 16.4628 23.5362 38.2769 -1.8179 -2.41291 -6.91424 +9632 4 16.622 23.8878 36.7607 -9.68345 -13.0364 13.8052 +9633 6 24.0933 14.3373 36.5438 -0.810617 7.47513 6.008 +9634 4 25.0172 14.0983 36.6068 9.64822 -3.29568 0.232999 +9635 4 23.7283 14.0715 37.4031 -3.57511 2.15125 -3.19243 +9636 6 27.4694 18.5535 28.7878 -22.2405 -8.90967 9.68842 +9637 4 27.2463 18.155 29.6474 7.14424 4.94771 -10.1046 +9638 4 26.6163 18.5328 28.3045 10.7583 2.44378 -0.411902 +9639 6 51.5617 10.4928 1.56364 -46.044 -5.31617 -17.9438 +9640 4 50.711 10.1131 1.91707 23.1705 13.8427 -10.0979 +9641 4 52.2015 10.4284 2.24991 18.8641 -3.04547 25.194 +9642 6 31.1163 39.6073 27.5052 16.7753 -4.77526 -29.689 +9643 4 30.6203 39.2762 28.2489 -5.6675 10.9492 15.0474 +9644 4 31.3773 40.5466 27.6182 -8.67746 -20.5696 10.3555 +9645 6 6.90447 35.9666 14.3264 -30.1691 -4.34312 14.222 +9646 4 7.61578 36.3042 13.808 21.2575 5.14969 -9.00238 +9647 4 7.11482 35.0613 14.5906 3.01946 -0.973686 -2.74545 +9648 6 45.5514 7.57029 29.1841 -25.615 -5.69379 -2.02895 +9649 4 44.9198 7.51228 28.4263 15.6429 0.393509 16.1679 +9650 4 45.0848 7.11279 29.9186 7.09759 5.05324 -8.24334 +9651 6 31.3626 20.5603 31.6216 46.5235 7.85379 -13.5612 +9652 4 31.9622 21.3332 31.7077 -20.5518 -6.12612 6.97271 +9653 4 31.9328 19.9839 31.0823 -17.3109 -3.90007 7.28444 +9654 6 43.0286 31.1606 10.377 -16.6603 7.93207 28.9623 +9655 4 42.0878 30.8529 10.4887 24.119 8.07098 -2.29185 +9656 4 43.3099 31.4942 11.272 -6.72297 -13.7816 -28.1326 +9657 6 50.925 25.5606 12.6461 -27.6852 -6.08767 20.8539 +9658 4 50.917 26.3683 12.1731 -8.31821 35.0391 -16.2433 +9659 4 51.8024 25.2628 12.5325 34.7451 -18.8429 0.848912 +9660 6 29.3305 2.97987 3.64738 17.2649 -36.5424 -5.61333 +9661 4 29.6156 3.84373 3.86529 8.03017 35.8359 9.57326 +9662 4 28.4158 3.03535 3.41816 -23.9953 6.75187 -10.8335 +9663 6 53.9216 32.1051 20.3724 -11.2223 -0.478332 -4.16652 +9664 4 54.8523 32.157 20.1701 8.27859 1.2318 1.83366 +9665 4 53.5473 31.7256 19.5583 -4.88871 3.83013 8.11791 +9666 6 41.7036 29.5569 6.48267 17.2638 16.7804 -5.64052 +9667 4 40.7698 29.5903 6.27928 -11.16 5.83742 -3.44443 +9668 4 42.1548 30.305 5.99503 -16.5783 -19.3567 12.2041 +9669 6 37.8345 24.5719 39.3019 -13.0469 -9.65298 -3.86921 +9670 4 37.225 24.2046 38.6488 4.5791 4.74434 1.49749 +9671 4 37.4276 24.3068 40.1372 5.55374 4.45167 1.85829 +9672 6 46.5621 27.5658 23.2944 -23.9279 -33.0439 -11.1022 +9673 4 46.4387 27.4786 24.2739 -2.64996 -4.90603 -22.3791 +9674 4 45.938 26.8598 22.8442 32.7587 35.3455 32.269 +9675 6 9.23408 27.197 8.34767 -28.7607 6.82988 18.9345 +9676 4 8.89078 27.6282 9.16421 9.10203 -8.06063 -16.3167 +9677 4 10.1694 27.1106 8.44975 24.8451 0.83524 4.07321 +9678 6 36.0586 34.168 13.9947 0.546429 -20.5208 -0.995849 +9679 4 35.8317 33.2019 13.9926 1.47243 21.3574 0.844463 +9680 4 36.7518 34.2454 13.3214 -1.12661 -0.38848 2.20278 +9681 6 51.6812 14.492 12.3108 14.2062 7.57429 -10.7818 +9682 4 52.2015 14.4126 11.4771 -7.23407 7.45688 18.698 +9683 4 51.902 15.34 12.7416 -3.60656 -14.3916 -9.37264 +9684 6 15.248 19.6366 32.4109 27.4357 -16.6396 -20.9158 +9685 4 15.2931 19.2358 31.5053 -3.54534 7.22564 18.4797 +9686 4 14.3328 19.7639 32.5881 -28.0981 2.1384 2.91772 +9687 6 27.6849 24.6479 38.3573 2.41004 -14.3506 -18.7558 +9688 4 27.9256 25.2107 39.0738 -0.349992 17.1553 25.2623 +9689 4 28.4455 24.6938 37.7731 2.45273 -2.47407 -6.18841 +9690 6 37.5344 9.26205 13.6222 2.62805 -1.42602 2.92011 +9691 4 37.9029 8.73293 14.3466 0.897712 0.834078 0.0180659 +9692 4 37.323 10.115 14.0326 -0.799981 -1.44542 -1.10758 +9693 6 20.9013 33.2307 26.2512 6.46074 3.54373 3.40895 +9694 4 21.2661 33.4546 27.1222 -3.70394 5.03607 -5.2507 +9695 4 21.0534 32.294 26.1755 2.06129 -12.757 -1.69162 +9696 6 6.58179 13.9421 35.2385 -0.161437 -23.8226 2.06013 +9697 4 6.46846 12.9778 35.1898 -10.847 5.63462 -0.921172 +9698 4 7.53649 14.0007 35.2781 8.40152 11.229 1.63712 +9699 6 10.0736 7.47184 6.87074 6.29005 1.76204 -5.26249 +9700 4 9.16789 7.18556 6.66525 -0.124912 3.45645 -0.864518 +9701 4 10.1825 8.41968 6.63706 -5.90018 -13.0861 3.35766 +9702 6 31.1989 5.96627 11.4256 47.5137 28.7614 23.6553 +9703 4 31.4466 6.13876 12.388 -20.2952 -9.94335 -33.1747 +9704 4 32.0308 6.26994 10.9806 -22.1211 -12.2896 5.82222 +9705 6 12.1387 3.84993 35.2935 2.49551 -0.304387 23.4243 +9706 4 12.8187 4.19174 34.7257 10.4227 4.50872 -14.559 +9707 4 12.5185 4.00559 36.1769 -9.60543 -1.42105 -7.76228 +9708 6 5.33665 6.07757 27.6447 8.69228 -34.5823 40.5077 +9709 4 5.10952 6.83187 28.1919 -5.14709 12.9851 -0.252954 +9710 4 5.24124 6.31071 26.7545 -7.00092 22.4827 -45.3835 +9711 6 13.1372 33.5675 1.68451 12.1014 31.5323 -4.45098 +9712 4 12.5865 33.1501 1.03303 -8.81838 -7.47149 -8.20936 +9713 4 13.3352 34.4765 1.32576 -5.5291 -24.3721 14.4697 +9714 6 44.6567 10.4099 29.0319 -12.4525 3.56979 -21.9228 +9715 4 44.5737 9.45178 29.0051 9.95574 -3.72472 2.79876 +9716 4 44.0317 10.7133 28.332 10.7873 2.60441 13.9487 +9717 6 9.14585 24.5947 6.38022 15.9839 26.3438 -7.73853 +9718 4 8.92734 24.382 5.47582 -9.1117 -9.61509 -8.5024 +9719 4 9.72625 25.3768 6.21639 -5.50996 -10.1894 15.5503 +9720 6 52.5653 27.2618 21.6392 -6.48047 6.16108 13.4347 +9721 4 52.5564 26.3196 21.8908 4.78081 5.6644 -14.1528 +9722 4 52.8195 27.3969 20.7225 3.24319 -11.7343 -6.41363 +9723 6 7.29679 16.9603 33.544 -1.27463 2.76823 -11.9762 +9724 4 7.39152 17.7215 32.9493 2.03275 -0.910573 2.88066 +9725 4 6.37085 16.7082 33.4809 -4.66481 0.778096 -0.770576 +9726 6 43.9289 25.2227 7.97871 -4.96366 -10.0233 8.38699 +9727 4 43.2519 24.7308 8.49213 12.2574 5.67032 -8.3389 +9728 4 43.4276 25.9018 7.51862 -3.04483 5.5605 -3.23664 +9729 6 2.07953 27.1233 13.6028 0.0104954 7.16496 -8.77242 +9730 4 2.15896 26.2371 13.9627 -2.1358 -7.6126 6.04882 +9731 4 2.6502 27.1018 12.8141 -2.23666 2.89631 3.72058 +9732 6 37.3141 18.284 2.18477 -5.94753 -1.23785 7.60386 +9733 4 37.4961 17.5691 1.55591 -3.17432 -0.490531 -1.7774 +9734 4 36.7255 18.8979 1.7415 -3.03937 1.4219 -5.67571 +9735 6 25.0022 10.0655 0.429871 -30.1443 -7.37242 -0.593153 +9736 4 24.272 10.366 41.7528 14.2211 1.75124 5.05026 +9737 4 24.5705 9.40237 1.00583 14.7283 12.1051 -6.86513 diff --git a/examples/amoeba/dump.water_box.amoeba.1 b/examples/amoeba/dump.water_box.amoeba.1 new file mode 100644 index 0000000000..9019401850 --- /dev/null +++ b/examples/amoeba/dump.water_box.amoeba.1 @@ -0,0 +1,7227 @@ +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.67966 7.08769 17.9461 -18.0057 -16.954 4.82612 +2 2 7.80945 6.75579 18.2607 19.8034 12.4721 -7.17463 +3 2 8.72223 6.81424 17.0254 7.13784 0.0282027 3.08606 +4 1 18.5257 8.24445 6.83762 8.52147 14.2257 60.5703 +5 2 0.216892 7.89544 6.05003 12.0964 -15.6711 -53.3384 +6 2 0.444268 7.82601 7.5302 -13.3675 6.47926 -9.3119 +7 1 8.37906 18.5504 6.81463 24.6094 6.61103 -1.11969 +8 2 9.34042 0.098069 6.73406 -18.7879 -2.64022 0.747908 +9 2 7.93962 0.573676 6.26984 -2.09268 1.16699 2.67386 +10 1 6.58995 1.84432 11.7198 46.7475 -13.739 -10.5489 +11 2 5.88543 2.40231 11.9251 -37.1346 27.545 16.57 +12 2 6.18153 1.06275 11.3693 -7.36455 -17.4045 -5.52161 +13 1 7.1466 5.75358 2.33152 -53.3657 41.599 -1.38826 +14 2 6.36812 6.12603 2.86268 38.0857 -22.9036 -2.95785 +15 2 7.02502 6.29465 1.5182 16.1101 -20.4591 11.2904 +16 1 16.2164 10.1388 16.1382 -32.9296 19.8915 17.3579 +17 2 16.9509 10.2747 15.5847 32.6569 -1.09677 -20.2087 +18 2 15.8498 11.0405 16.2399 2.59134 -12.8635 2.30838 +19 1 10.6046 15.0374 2.30369 -9.45108 -28.933 -9.95229 +20 2 10.5292 14.3949 3.01849 1.67759 -0.529274 5.48943 +21 2 11.0236 15.78 2.70962 13.2591 21.3673 6.11781 +22 1 17.1624 8.24409 10.3708 10.41 5.9387 11.3227 +23 2 16.5528 8.68798 10.966 -4.81374 9.55532 3.583 +24 2 17.9421 8.82333 10.3208 -3.63548 -8.99367 -3.64514 +25 1 14.901 15.8652 16.3167 21.2892 -10.1645 16.79 +26 2 14.0225 16.1982 16.2525 -30.7371 12.6366 -7.00126 +27 2 14.9141 15.482 17.2099 1.64171 -7.21798 -3.7798 +28 1 12.1752 13.3771 0.408263 -10.449 7.39269 11.8256 +29 2 12.0579 13.8465 18.23 5.34035 -4.48355 -17.1718 +30 2 11.6217 13.8904 1.00796 2.45905 -0.157672 9.39156 +31 1 9.27358 5.34243 4.05546 -29.354 32.8373 13.3322 +32 2 8.64594 5.4665 4.83764 23.9402 -17.6274 -26.2044 +33 2 8.74177 5.68615 3.30282 4.39732 -15.4932 8.77495 +34 1 1.83016 4.27673 11.6495 -22.4867 33.9085 -11.1027 +35 2 1.70328 5.22377 11.9391 5.26663 -24.2909 -6.35354 +36 2 2.40811 3.85345 12.2597 16.6835 -12.3735 20.3319 +37 1 1.96438 6.83299 8.3731 -11.8866 6.09586 -26.8326 +38 2 2.49614 7.21578 9.0563 11.4719 0.0715494 18.6532 +39 2 1.81128 5.90585 8.57354 7.57659 -6.58781 5.32172 +40 1 5.40557 4.38899 7.93274 -5.84675 9.40812 -2.24834 +41 2 5.53738 3.43895 7.78131 -7.95286 9.95376 -0.129754 +42 2 4.75516 4.73491 7.29062 11.2407 -18.5615 7.61563 +43 1 3.23 2.92842 17.5524 1.14755 15.2746 17.0601 +44 2 3.93109 3.19827 16.9402 0.871842 10.3641 0.782189 +45 2 3.00444 3.70897 18.1497 2.9668 -26.2705 -22.3315 +46 1 7.4624 5.26283 6.13117 4.99569 4.7543 -2.87263 +47 2 8.02565 5.58849 6.88177 -21.8117 -10.641 -11.2175 +48 2 6.93508 4.45577 6.3254 15.5754 16.5621 10.3274 +49 1 9.77896 7.02384 11.9834 11.1892 -4.91774 24.9965 +50 2 10.2721 6.37256 11.5011 12.944 -11.2243 -3.64487 +51 2 9.1532 7.31587 11.3499 -25.3515 14.1302 -21.9158 +52 1 14.1167 3.54999 8.03003 -26.7224 -2.96987 -36.9282 +53 2 13.4732 4.22413 7.73132 14.0058 -9.36539 3.16858 +54 2 14.3809 3.80189 8.88487 12.5079 17.7406 36.8421 +55 1 4.82329 17.2568 4.03846 -17.1239 31.8599 -29.451 +56 2 5.49315 17.973 4.01308 -7.2715 -20.7015 10.2799 +57 2 4.18746 17.5412 3.33843 11.1391 -13.8034 10.6312 +58 1 16.4918 16.6259 10.0493 30.7319 18.7558 -40.9431 +59 2 16.1673 16.3226 10.8594 -24.9276 -14.9205 38.9888 +60 2 15.9925 16.2084 9.33562 -5.59472 -4.21747 7.16045 +61 1 1.94489 4.93323 0.49791 29.2037 9.87254 4.22328 +62 2 2.55322 5.26335 1.2053 -16.134 -9.14189 -14.6469 +63 2 2.08253 5.591 18.4408 -15.0883 -1.49688 2.64821 +64 1 11.816 13.3571 16.2711 -9.40148 3.94995 7.41554 +65 2 11.2371 12.6203 16.5671 11.2868 -0.226619 -16.3723 +66 2 12.2446 13.1893 15.4079 -8.93504 -7.51369 10.5349 +67 1 10.105 11.0651 16.9545 19.171 -30.5561 3.11717 +68 2 10.5674 10.1947 17.1295 -13.2328 27.8223 -6.21699 +69 2 9.25349 10.8067 16.5912 -4.96621 2.04172 2.74708 +70 1 11.7264 17.5421 13.4742 -3.04385 -27.7441 -11.1528 +71 2 12.2771 16.9836 12.8968 -5.80236 0.92931 5.24929 +72 2 12.1041 18.3936 13.317 3.92972 25.4072 2.69815 +73 1 6.33029 9.31911 12.2264 14.5686 -26.7823 -24.0739 +74 2 7.02603 8.96242 11.6353 -16.9594 2.64581 0.0898615 +75 2 6.81249 9.95941 12.7172 6.645 23.591 18.9185 +76 1 16.2187 12.7249 2.70186 -8.60429 -40.8729 7.98732 +77 2 17.0292 13.1566 2.50302 21.6794 20.3416 -10.6726 +78 2 15.4982 13.3357 2.61812 -11.4268 23.7847 2.88762 +79 1 0.637202 12.5625 5.84914 -31.8402 8.87564 3.58131 +80 2 0.892312 12.5507 4.90771 -4.9886 -2.92912 11.9697 +81 2 18.3039 12.804 5.85329 37.806 -5.77498 -8.15105 +82 1 5.19922 16.3781 18.5047 -8.79571 2.1563 -13.4584 +83 2 5.80284 15.8543 17.9455 2.86332 8.92403 13.1762 +84 2 5.67034 16.9636 0.462296 7.01287 -6.10758 -1.1835 +85 1 0.510145 7.62945 4.0545 45.1401 15.6351 -20.049 +86 2 18.5719 8.14656 3.45296 8.17292 -14.6601 7.70417 +87 2 1.46496 7.74082 3.66917 -48.4928 -0.554047 23.6518 +88 1 3.14672 8.89584 6.52626 -55.2927 3.32392 -1.46176 +89 2 3.50609 8.59991 7.35294 11.5609 -2.03159 9.82262 +90 2 2.14573 8.92962 6.68203 43.6989 0.357582 -10.1043 +91 1 7.30854 10.3037 16.1717 1.78466 -0.469392 13.5048 +92 2 6.56213 10.4624 15.5802 -0.177974 -0.17468 9.69093 +93 2 6.99303 10.278 17.1118 -1.93161 2.46429 -18.5659 +94 1 11.1122 1.06968 4.98939 -2.5529 -18.3754 16.0671 +95 2 11.0776 1.97142 4.64864 2.28669 -2.46607 -13.2595 +96 2 10.7048 0.433547 4.37027 3.43033 14.549 -3.59534 +97 1 4.45204 2.70061 13.2052 -5.66348 -30.5004 33.0628 +98 2 4.60333 3.05865 14.0914 -1.92534 16.2672 -14.1546 +99 2 4.38645 1.737 13.4626 -0.349226 19.9023 -23.5316 +100 1 8.42792 10.0237 1.78469 -10.3917 -19.899 15.7952 +101 2 8.3405 10.6377 2.53622 4.61332 0.207175 -2.25283 +102 2 8.49672 9.11244 2.17467 4.01989 28.7847 -10.326 +103 1 10.5335 1.75383 15.546 -34.1458 -0.453574 1.15961 +104 2 11.3977 1.82718 15.9216 24.1476 -5.37633 -0.0681618 +105 2 10.5608 1.78317 14.5837 3.50677 3.31298 -0.339701 +106 1 2.77693 12.941 7.74821 -10.4378 -0.583625 -1.53852 +107 2 3.28797 13.5733 7.23382 6.48403 3.62296 3.43855 +108 2 1.98704 12.8256 7.20013 3.29426 -8.64685 -0.0486837 +109 1 3.63517 11.6895 5.33963 -11.8109 -10.1864 -4.68879 +110 2 3.35385 11.0502 6.03137 5.66752 13.6786 -16.6554 +111 2 2.8758 11.855 4.74058 12.1084 -4.04172 11.1294 +112 1 6.88803 14.474 16.8428 -11.4129 11.5698 10.6698 +113 2 7.55973 13.8293 16.6383 5.64016 -3.74285 -2.32739 +114 2 6.60381 14.8838 16.0165 -1.10143 -9.42407 -1.70294 +115 1 14.1722 14.5374 3.41536 22.8916 -3.95473 -24.8295 +116 2 13.6514 15.2845 3.14096 -10.2906 15.0357 0.984662 +117 2 13.8512 14.2508 4.25439 -13.7068 -8.63673 17.9444 +118 1 8.28226 18.1809 16.0824 -12.751 -14.2632 -6.38017 +119 2 8.77677 17.3494 16.3071 3.86396 27.0257 -3.69586 +120 2 8.7603 0.384816 15.9919 13.8336 -15.3184 3.9152 +121 1 4.73724 1.61643 4.90111 4.42093 34.2728 -25.3552 +122 2 3.96969 2.16837 5.15263 7.5353 -10.5013 -8.47368 +123 2 5.18465 2.1484 4.15475 -16.3947 -25.6944 40.0476 +124 1 15.1457 12.8616 16.4403 -17.2871 -9.38827 44.2976 +125 2 14.6041 12.8692 17.2613 20.1997 8.40389 -10.3991 +126 2 14.49 12.6307 15.8136 -19.9308 -5.03226 -40.1466 +127 1 15.779 18.3837 16.786 46.4421 11.1965 42.4368 +128 2 16.5108 18.615 17.4688 -40.0732 -8.23978 -31.409 +129 2 15.7694 17.4186 16.7687 -10.9286 -0.13557 -0.275231 +130 1 1.1383 1.1331 16.5571 -3.78806 10.8903 6.59298 +131 2 1.96551 1.50352 16.9177 -13.4358 3.04324 -1.88802 +132 2 0.420521 1.53444 17.0916 18.9396 -8.74897 -5.5358 +133 1 18.0817 4.5907 15.863 15.5867 -18.8741 -0.0488223 +134 2 18.5818 3.91936 15.3489 -11.2031 15.1049 7.34982 +135 2 18.5602 4.7339 16.6874 -0.349245 -1.77666 -1.18458 +136 1 12.22 16.9378 16.1148 -5.50141 -11.6153 60.0453 +137 2 11.409 16.6934 16.6676 25.9686 4.83442 -31.2532 +138 2 11.9646 17.3216 15.2917 -16.184 2.10738 -25.7541 +139 1 15.8709 2.55221 17.9707 -0.937802 24.4841 -15.6355 +140 2 15.7355 3.48355 18.2574 7.57333 -26.0521 3.95198 +141 2 15.6659 2.59235 17.0072 3.66916 -5.77112 18.206 +142 1 6.70868 13.791 10.2637 2.56639 25.7323 0.00368182 +143 2 6.59347 13.548 11.1958 -0.357243 -4.92282 -5.01928 +144 2 6.58252 13.0514 9.6765 -3.72683 -17.1721 -0.802691 +145 1 10.146 18.2027 2.80372 18.7695 36.9578 -11.0057 +146 2 10.2207 0.331961 2.18345 -3.04248 -21.6078 13.7214 +147 2 9.26571 17.8868 2.67703 -19.5044 -8.44618 -8.21612 +148 1 2.97538 17.748 6.06078 -25.8303 0.797173 6.8887 +149 2 2.09399 17.6473 5.67013 0.763714 -3.05404 12.9421 +150 2 3.45883 17.8838 5.26396 31.3429 0.483929 -10.2997 +151 1 12.558 17.0134 7.97028 5.92903 -16.4499 -7.28316 +152 2 11.9572 16.2512 7.82085 0.921176 10.9238 13.6165 +153 2 12.4657 17.4524 8.83591 -10.9555 -3.32417 -4.29455 +154 1 14.8795 15.2862 8.28544 4.29768 -18.9738 42.4504 +155 2 13.9824 15.6136 8.40666 -1.92729 9.60106 -14.0248 +156 2 15.2312 15.4641 7.43118 3.9302 10.2131 -33.7787 +157 1 17.5429 18.3228 0.375372 -51.2916 -3.32975 -15.7386 +158 2 18.116 17.6308 0.128652 39.2354 -21.6017 -8.51882 +159 2 17.9698 0.288559 0.934677 25.0864 23.4945 21.3611 +160 1 0.910209 10.3712 1.41143 1.2541 -53.8465 46.4292 +161 2 0.158544 9.88347 1.87089 19.8792 18.5163 -27.3041 +162 2 0.565924 11.0969 0.944383 -23.7591 37.8535 -27.1782 +163 1 1.55407 12.175 3.31087 17.0236 24.8743 53.6813 +164 2 1.36245 11.4802 2.72234 -7.32763 -23.5838 -35.6732 +165 2 1.61623 13.0206 2.87285 0.136729 5.19924 -18.0355 +166 1 0.543127 17.2543 4.88609 31.8084 34.0538 -50.8525 +167 2 0.11032 17.9772 5.31124 -21.3387 12.8349 12.3342 +168 2 0.420366 16.4266 5.2673 -11.294 -44.4064 35.6607 +169 1 1.10053 1.01949 9.38768 20.2638 -3.47079 3.57058 +170 2 1.46081 0.575286 10.1589 5.67003 5.93636 13.5245 +171 2 0.265613 0.594128 9.34525 -28.6257 -3.15214 -10.2647 +172 1 16.8007 2.32783 13.2877 6.99662 17.0137 -29.7497 +173 2 17.0701 2.57314 12.3549 -10.9982 -8.19012 27.7721 +174 2 16.4263 1.43993 13.282 0.147057 -7.47121 1.20179 +175 1 2.45231 15.8283 12.1942 24.161 -10.1121 18.9704 +176 2 2.8623 15.5513 13.0537 -7.72007 6.59246 -26.0318 +177 2 2.91392 15.3801 11.4615 0.0476102 5.48907 2.61928 +178 1 16.435 15.531 5.9458 18.7492 36.0842 -19.2976 +179 2 17.3808 15.5177 6.20547 -11.8351 -4.55683 5.24266 +180 2 16.4147 16.2211 5.22063 -11.381 -14.928 22.2973 +181 1 5.84547 5.02056 11.8065 17.7106 -18.2202 -11.4458 +182 2 5.55799 5.91374 11.8891 -12.2572 20.16 10.1838 +183 2 5.09 4.45915 11.9819 -6.52029 -3.58907 3.63352 +184 1 15.2214 4.86555 0.731755 -13.1216 -14.4231 22.9417 +185 2 14.6776 4.45845 1.47821 22.203 16.7553 -20.5876 +186 2 14.6696 4.95834 18.5986 -12.3693 6.08689 2.65647 +187 1 16.3401 16.2933 2.11217 18.14 -13.9799 -32.9854 +188 2 16.0666 16.7695 2.87319 -13.0548 23.8975 25.5489 +189 2 16.7601 16.9279 1.50378 -12.2165 -0.858221 10.4248 +190 1 0.305885 4.87877 3.79118 -8.03527 51.7998 21.7755 +191 2 0.299338 5.85541 4.09758 -2.9952 -44.8334 -24.4202 +192 2 1.16991 4.5635 4.03062 6.79251 -10.5604 -0.715716 +193 1 2.92501 14.9782 15.0356 -0.55527 3.1583 33.427 +194 2 3.0159 14.7264 15.9987 -0.365372 -5.40078 -25.4532 +195 2 2.35392 15.7535 15.1247 4.98076 9.37108 -6.84819 +196 1 1.1115 14.5727 9.55731 53.2995 18.2393 -15.0567 +197 2 2.08491 14.4157 9.46275 -24.2978 21.5236 -5.71591 +198 2 0.897072 13.7408 9.90248 -27.8007 -35.1999 18.1171 +199 1 13.6501 16.6688 11.5433 6.47975 17.456 -8.04391 +200 2 13.4697 17.4567 10.9694 -3.73037 -22.0736 15.6897 +201 2 13.5721 15.8897 10.9842 -9.76738 -0.866763 -1.05724 +202 1 4.73098 1.47842 0.720986 0.301824 -3.12152 0.469647 +203 2 4.27169 1.98826 0.034225 -8.26683 -3.93854 8.43126 +204 2 4.11741 0.788607 1.06182 2.96071 12.6313 -1.58966 +205 1 1.42158 18.4663 11.9139 -14.1117 26.2958 -21.249 +206 2 1.21766 0.394331 12.6648 1.16138 0.455671 2.39682 +207 2 1.94844 17.765 12.2423 13.6408 -23.7742 11.0988 +208 1 11.5498 10.1018 4.11619 25.3456 17.7005 -19.3629 +209 2 11.5687 10.5955 3.24216 -3.14233 -16.3641 23.7483 +210 2 12.4899 10.1059 4.45555 -25.4417 -1.6091 -14.3563 +211 1 8.38254 12.182 3.76573 -28.852 -4.31545 3.66513 +212 2 9.25863 12.501 4.06076 -17.1001 4.9792 7.32521 +213 2 7.63736 12.4251 4.40785 39.3791 -3.23553 -14.7997 +214 1 14.3228 4.03714 3.29709 9.27375 -1.14036 13.2131 +215 2 14.8928 4.14179 4.10547 -9.51715 0.900554 -20.2647 +216 2 13.4701 4.45558 3.48891 4.64833 -1.13545 4.69814 +217 1 5.58188 1.78199 7.50513 -29.4992 -43.0538 46.7434 +218 2 5.0172 1.13958 8.12095 30.2312 35.5173 -41.7355 +219 2 5.33078 1.59122 6.59529 -0.079259 -3.9625 -11.0752 +220 1 17.9086 1.12503 4.88467 2.95857 -4.16946 -9.18468 +221 2 18.4038 1.54032 4.14207 -4.82318 -1.26447 16.1692 +222 2 17.6814 1.78344 5.55455 4.62183 1.86586 -4.7268 +223 1 6.83101 9.39303 4.49716 -16.0719 2.4093 -32.0921 +224 2 6.83675 9.57499 5.42715 5.68499 0.0447418 21.7322 +225 2 7.66807 8.99049 4.24996 11.5264 2.90932 7.40733 +226 1 2.71406 14.9654 1.962 -15.6661 -3.22344 -28.3015 +227 2 3.33343 14.7912 2.66354 12.1361 -6.91733 6.37301 +228 2 3.09502 14.6645 1.10257 -2.31521 10.6903 23.881 +229 1 17.279 12.8803 13.1283 -15.852 18.187 11.8592 +230 2 16.4044 13.2339 13.3283 -9.52452 -19.4408 0.302495 +231 2 17.6948 13.7346 13.0834 29.0619 4.95471 -11.8483 +232 1 15.0196 10.5818 1.38314 -38.2265 -36.9922 -31.977 +233 2 15.5102 11.1963 1.85791 34.2907 40.991 28.9525 +234 2 14.3351 11.0964 0.933298 3.32659 -5.3471 5.33786 +235 1 5.71789 6.95838 4.52856 0.683996 -27.8748 7.64407 +236 2 5.85266 7.87985 4.34179 3.58991 17.4746 0.820156 +237 2 6.44364 6.70841 5.13514 -10.315 -1.76088 -5.92415 +238 1 8.12142 8.26262 10.159 -0.695069 1.43108 44.445 +239 2 8.58519 8.93965 9.66877 7.60931 4.76567 -12.7632 +240 2 7.56021 7.74854 9.59836 -11.8614 -6.52029 -23.2391 +241 1 13.5311 18.2901 5.8079 -10.639 -13.2321 14.1155 +242 2 12.703 0.102298 5.56963 3.89465 4.4637 5.13268 +243 2 13.2939 17.6289 6.50758 1.00889 22.2284 -14.4481 +244 1 0.327324 2.56344 0.113251 1.70035 12.7901 -0.992224 +245 2 18.009 2.52214 18.5736 8.63965 15.9711 4.89881 +246 2 0.724331 3.48299 0.160564 -21.1536 -24.6374 0.514976 +247 1 12.6396 10.9599 9.76875 -56.8672 19.3176 -11.2335 +248 2 11.6552 10.7306 9.75031 35.1307 23.7735 -5.55284 +249 2 12.944 10.1383 10.0842 27.9729 -33.5927 10.4043 +250 1 0.789377 12.2851 11.08 11.4395 6.49483 14.2632 +251 2 18.4919 12.3017 11.2021 -18.2818 -3.30898 -6.09679 +252 2 1.09088 12.7637 11.8722 5.75277 -12.0493 -6.6955 +253 1 5.04567 7.2193 13.4912 -21.0137 -4.20407 -15.1033 +254 2 5.59899 7.84649 13.0247 8.33052 12.0635 4.31379 +255 2 5.48047 6.97898 14.3058 12.3979 0.954472 8.53674 +256 1 1.28609 6.99027 11.837 -51.8154 -68.8711 -15.2848 +257 2 0.481329 7.14037 11.2978 13.8945 0.267944 10.341 +258 2 1.71601 7.79102 11.8803 31.2664 60.1884 9.92158 +259 1 15.4442 9.46712 12.3088 17.5832 34.764 29.4487 +260 2 15.6103 10.4448 12.4444 -11.1607 -30.7672 -13.8763 +261 2 15.5582 9.10301 13.208 -6.74487 -0.409264 -16.2653 +262 1 16.6404 12.9744 5.44078 0.476019 -21.9889 6.56196 +263 2 16.2955 13.8866 5.54247 3.20084 -14.9841 -16.6056 +264 2 16.51 12.593 4.54035 -6.85686 22.0547 12.2483 +265 1 6.17495 10.0683 0.210584 -24.8048 -7.78292 -31.6597 +266 2 5.35839 10.4511 0.557392 3.36584 -0.936069 -2.46609 +267 2 6.76092 10.0813 0.943985 27.7338 0.90169 16.297 +268 1 12.3644 6.05734 4.04236 -18.3706 -38.3329 30.2118 +269 2 12.4738 6.70802 3.38308 -4.23006 32.9396 -25.2938 +270 2 11.4212 5.77124 4.03221 17.6012 8.78206 -0.800798 +271 1 0.124733 12.8266 0.203961 3.20067 -1.28022 -4.47052 +272 2 0.029974 13.5935 0.786871 -4.13202 -3.19163 0.984476 +273 2 18.185 12.9963 18.0877 7.32574 2.49628 4.77591 +274 1 3.83931 18.5785 8.61972 20.3146 -6.32916 -11.386 +275 2 3.58625 18.36 7.70531 -8.03976 -3.33875 5.01892 +276 2 3.07994 0.282626 9.06556 -19.534 7.19375 -0.404578 +277 1 7.37599 17.2741 4.45241 46.8945 31.0513 1.9622 +278 2 8.02493 17.9603 4.76808 -26.2103 -24.7083 -3.79352 +279 2 7.47725 17.3636 3.49301 -14.0292 -8.10987 6.13371 +280 1 9.20909 17.0315 12.2197 40.0448 -1.21715 18.2255 +281 2 9.48765 16.172 11.8421 -14.9023 11.2095 -3.08284 +282 2 9.99892 17.2887 12.7762 -22.6762 -6.36186 -10.9913 +283 1 13.3284 13.0292 7.94175 -54.0325 -32.963 -10.3586 +284 2 13.0533 12.253 8.47808 14.6554 7.99008 1.85075 +285 2 14.1985 13.2855 8.14946 35.8516 11.3519 14.341 +286 1 14.9871 2.94126 15.3478 14.8638 12.3357 -7.44451 +287 2 14.2243 2.52816 14.9303 4.35222 -7.49481 -2.56315 +288 2 15.7054 3.02501 14.6718 -19.1947 -5.47381 11.1555 +289 1 9.85637 15.4939 17.0026 4.34281 7.61827 -6.92944 +290 2 10.2013 14.6312 16.7411 4.19591 2.79737 -1.68983 +291 2 9.35728 15.3668 17.8085 -9.66212 -2.87408 7.84053 +292 1 11.2848 8.23994 16.5492 3.25751 34.7591 1.5155 +293 2 10.8315 7.75123 15.8747 -12.3664 -15.1549 -6.58201 +294 2 11.7506 7.62533 17.1016 5.33248 -14.8245 8.28699 +295 1 3.77097 18.1898 16.7118 4.01905 33.5947 11.0152 +296 2 4.24576 17.6768 17.3569 8.65949 -22.0954 6.28955 +297 2 3.7978 0.441972 17.1008 -4.25038 -14.6471 -12.4326 +298 1 2.20581 4.09889 8.95874 2.08991 2.93543 4.28652 +299 2 3.00197 3.55544 8.74643 -14.7124 14.9899 14.3923 +300 2 2.10364 4.24367 9.94001 10.2614 -16.6264 -23.5165 +301 1 9.9196 10.3581 9.75231 -25.3187 14.4865 -18.1673 +302 2 9.34403 11.1055 9.40387 23.5511 -18.6954 16.391 +303 2 9.87032 10.282 10.7171 2.48436 10.3271 -7.39297 +304 1 9.73405 0.807167 10.8572 20.2474 21.386 4.54274 +305 2 9.58177 18.5811 11.2204 -17.7151 -14.7389 -0.277185 +306 2 9.10878 1.03014 10.1675 -11.7891 -3.63679 -6.29284 +307 1 9.18221 15.2247 10.2123 -13.9791 -9.46207 -17.3808 +308 2 9.04674 16.0847 9.7631 0.486754 -17.6411 9.75771 +309 2 8.3908 14.6843 9.94105 18.1048 12.7648 16.7376 +310 1 1.00316 9.27987 10.329 16.2357 -30.0069 -12.307 +311 2 1.16727 10.1904 10.5724 12.5584 13.4462 -0.132091 +312 2 1.84996 8.76119 10.1498 -29.1191 35.4904 9.82697 +313 1 16.8004 4.89338 8.19813 20.3933 -12.8673 28.5682 +314 2 16.1748 5.31624 8.83318 13.8703 -8.22156 -17.3769 +315 2 17.4877 4.38941 8.71628 -28.7666 17.1718 -13.9408 +316 1 14.6379 14.6893 0.402347 -11.3933 -1.08114 12.583 +317 2 14.9609 15.3376 1.05877 1.73558 -10.8431 -5.12344 +318 2 13.9048 14.1906 0.841144 16.133 14.0369 -13.7985 +319 1 3.51181 11.0525 9.63829 3.71178 7.51059 -9.42611 +320 2 3.41507 11.3617 10.5484 4.21267 3.5616 -2.2445 +321 2 3.25155 11.8076 9.06383 -1.86739 -11.3951 3.16022 +322 1 11.0289 10.8695 1.26208 17.5529 18.9634 -6.32419 +323 2 11.1535 11.716 0.753779 -2.53448 -25.7082 13.9861 +324 2 10.1142 10.5923 1.16471 -5.76816 1.63272 -1.45278 +325 1 13.2239 7.06188 12.8977 -31.5053 10.0751 -2.41927 +326 2 14.1381 6.84046 12.8922 27.4331 -7.40558 0.979603 +327 2 12.7471 6.22139 12.9668 2.74296 5.12722 -5.48309 +328 1 9.62584 1.88878 0.937813 20.2039 -2.98483 37.6532 +329 2 8.77484 2.11506 0.623903 -27.5663 2.83673 -14.773 +330 2 10.1764 1.70882 0.191067 9.03311 -1.803 -18.3794 +331 1 10.6054 13.537 4.7508 -5.88392 -4.211 -2.61457 +332 2 11.3208 12.9359 5.04367 -2.43279 15.5075 -5.53386 +333 2 10.4128 14.1619 5.47507 10.6777 -11.2442 -5.71889 +334 1 14.2525 1.6915 10.8868 22.6682 20.2673 6.9187 +335 2 15.0842 1.26497 10.6465 -0.175006 -8.05208 -4.1062 +336 2 14.5069 2.62992 10.8824 -12.4791 -0.486299 1.09093 +337 1 14.6678 12.4248 11.7157 -13.2082 -11.6835 -6.16669 +338 2 15.5574 12.5766 11.3177 -21.8957 -10.6844 -5.73724 +339 2 14.0022 11.9667 11.1187 29.6297 15.7618 7.64488 +340 1 8.24065 5.08218 9.78509 -6.47861 44.5837 29.4664 +341 2 7.45364 5.10173 10.3836 14.047 -11.9893 -18.2698 +342 2 8.36822 4.22882 9.41503 -9.58488 -33.9934 -8.19516 +343 1 1.59893 16.8132 18.3262 1.96117 45.1636 -18.3395 +344 2 1.99225 17.1675 17.4932 -11.7114 -3.37836 17.8399 +345 2 1.72693 15.8931 18.2458 8.8364 -33.8164 2.61771 +346 1 1.43382 17.2563 15.3383 72.5903 -10.7327 -13.0674 +347 2 1.32309 18.1562 15.5759 -7.01853 28.114 11.2541 +348 2 0.623143 16.841 15.3782 -65.0193 -20.0106 1.99827 +349 1 3.73599 5.55499 6.2196 -15.153 37.171 -3.6345 +350 2 3.32092 6.26594 6.76194 -0.427016 -18.6419 -6.59332 +351 2 4.19567 6.05321 5.52665 9.16489 -2.39818 -0.177123 +352 1 12.357 9.41487 14.1826 14.7553 -23.0333 -0.513454 +353 2 12.9591 8.63784 13.9021 -31.7094 29.7183 13.6876 +354 2 11.936 9.15457 15.0346 15.6336 0.764049 -11.787 +355 1 4.0362 15.2647 6.90572 29.1452 22.7898 -8.55589 +356 2 3.45744 16.0249 6.7945 -6.03593 0.633302 -6.25525 +357 2 4.92941 15.6518 6.66696 -24.7672 -22.8121 8.07817 +358 1 0.606517 8.56128 14.8606 8.16327 11.3924 -6.42857 +359 2 0.498099 9.52604 14.9437 -1.3098 -5.53798 5.35752 +360 2 1.28855 8.50016 14.167 -7.84877 -5.15776 5.22176 +361 1 12.9763 8.3683 10.3434 -0.844759 8.90572 -31.1716 +362 2 13.7163 7.90436 9.89822 -4.62341 -2.31264 17.3373 +363 2 12.9003 8.0957 11.2534 8.39581 -13.8091 14.665 +364 1 15.2983 7.63672 3.47583 -36.1974 -22.3868 30.0346 +365 2 14.5024 7.10501 3.29647 15.8969 13.8763 -24.8874 +366 2 15.2922 7.47095 4.43335 27.1257 13.219 -1.62631 +367 1 17.3208 6.63818 0.028906 -14.8751 21.4285 -7.11338 +368 2 16.7479 6.05403 0.554933 2.23596 0.744461 -7.2242 +369 2 16.7141 7.27151 18.2009 9.57247 -21.991 17.917 +370 1 8.79355 6.92545 7.84172 -22.0329 -24.5159 21.3067 +371 2 9.63968 7.32585 7.85068 36.717 16.3192 -5.46325 +372 2 8.77688 6.39871 8.67404 -5.56167 6.19415 -17.3543 +373 1 12.3209 0.607808 1.1741 -8.60043 -0.59496 -5.94607 +374 2 12.995 1.15082 1.58835 11.0262 -7.11766 4.69751 +375 2 12.79 18.5825 0.66073 -1.01688 3.73434 3.9163 +376 1 5.68514 15.097 14.5145 8.08213 26.2607 -13.8654 +377 2 4.72797 15.1695 14.4772 -8.65505 -1.66018 8.38379 +378 2 6.02476 15.8935 14.032 -4.56821 -16.9623 16.8148 +379 1 3.822 6.53853 1.67803 10.5239 -7.29529 -10.476 +380 2 3.54968 7.33117 1.17576 -0.94291 -9.86176 19.1013 +381 2 3.81642 6.7886 2.60252 -1.1437 7.90849 5.70077 +382 1 3.89262 11.6088 12.227 12.6183 0.535598 5.61903 +383 2 4.72051 12.1032 12.348 1.21499 -6.42147 -0.654839 +384 2 3.26281 12.0921 12.7526 -15.9809 8.56892 5.74885 +385 1 5.45444 3.88172 15.8755 8.44756 62.1439 23.7417 +386 2 5.90627 3.24049 15.3708 26.1603 -31.2362 -14.1171 +387 2 6.11665 4.65725 15.9739 -35.5554 -35.0069 -5.06549 +388 1 14.4636 10.317 4.39501 5.54347 -18.2961 -43.8287 +389 2 14.9051 9.88853 5.13417 0.162303 -5.91623 3.64337 +390 2 14.7084 9.81768 3.53446 -11.8135 21.0668 42.8202 +391 1 7.94949 17.2895 9.24469 -10.6799 8.8199 -1.02562 +392 2 7.23447 17.5423 9.86969 8.35341 2.50468 -15.9799 +393 2 8.01085 17.8889 8.47627 -8.2125 1.31495 9.33291 +394 1 4.4986 14.4237 3.96317 23.4879 4.54475 27.495 +395 2 4.89523 15.3318 4.14709 -14.6852 -27.1979 0.729547 +396 2 4.80237 13.7713 4.67129 -11.1841 28.5155 -20.9146 +397 1 14.3358 7.38467 15.7635 18.2582 5.36164 1.70543 +398 2 15.2401 7.23754 15.391 -25.5283 4.5174 14.2628 +399 2 14.4998 7.83446 16.6232 -7.00614 -11.7321 -15.3353 +400 1 2.86875 18.2246 1.90934 11.7547 29.7641 47.6357 +401 2 2.54447 17.7626 1.17928 -20.4445 -34.8995 -41.4626 +402 2 2.08284 18.4154 2.45796 12.4063 3.86937 -8.17484 +403 1 7.96139 1.61197 4.52525 30.3503 -5.61589 29.1814 +404 2 7.4985 1.83317 3.72811 -5.85178 12.6793 -14.6648 +405 2 8.84188 2.051 4.57628 -22.8061 -6.44347 -10.2559 +406 1 2.69247 14.1251 17.7583 -44.9975 -8.30966 9.027 +407 2 1.78944 13.8074 18.0556 29.9332 0.951363 -12.1679 +408 2 3.33089 13.517 18.1683 -0.885538 6.08231 -6.55793 +409 1 0.711797 1.68055 13.8626 46.1903 -0.903658 -18.4125 +410 2 0.854596 1.56791 14.7929 -3.1534 -4.53792 18.4431 +411 2 18.4557 1.86826 13.7064 -36.4408 7.03813 3.66844 +412 1 4.5582 18.5986 13.9691 16.7448 -5.62304 -20.7496 +413 2 5.37614 18.0918 13.7297 -17.5024 17.6116 13.2075 +414 2 4.4096 18.4453 14.9034 -5.9637 -5.97884 8.59903 +415 1 7.10973 0.453475 18.3742 -15.9095 45.4284 35.234 +416 2 6.99644 0.098599 17.5235 1.36411 -17.312 -40.4978 +417 2 6.34312 1.05085 18.5323 11.251 -17.9428 -0.916775 +418 1 16.0934 18.4421 14.1505 -12.1616 -21.5095 -38.715 +419 2 15.444 17.7866 13.7542 19.2119 24.6311 23.4234 +420 2 16.0379 18.4915 15.109 -11.392 0.0248185 1.48898 +421 1 10.1156 4.52417 16.2956 -62.1497 -10.7811 -30.3439 +422 2 10.9808 4.34247 16.5381 55.5233 -0.530433 19.4573 +423 2 9.84863 3.69679 15.8473 1.30878 12.8229 10.5952 +424 1 15.8226 17.9425 4.41327 -8.6596 2.53656 28.4341 +425 2 16.5547 18.5732 4.53052 -7.53986 -1.28134 -1.76301 +426 2 15.1071 18.2295 5.06915 24.8326 -13.5436 -35.3744 +427 1 6.9246 17.3574 13.7412 35.4232 12.1969 -4.79491 +428 2 7.49648 17.8115 14.4369 -19.095 -19.6264 -17.6052 +429 2 7.52703 17.1963 12.9658 -8.44681 6.90552 21.4872 +430 1 13.2892 6.57209 6.73437 -47.4462 -6.01427 11.894 +431 2 14.2146 6.66317 6.83486 37.5911 0.460957 -13.6759 +432 2 13.0394 6.38579 5.82242 8.60231 0.411312 -6.48828 +433 1 7.6616 2.3861 9.17526 11.1339 -5.58665 -35.6695 +434 2 7.32169 2.39592 10.0555 -17.0215 -5.04529 20.6135 +435 2 6.95914 2.1022 8.53308 18.7558 7.43711 21.2842 +436 1 15.1464 14.8771 13.6482 -7.73724 1.21311 0.537171 +437 2 15.0308 15.0223 14.6069 -1.84691 1.26092 -11.2626 +438 2 14.3194 15.1152 13.1798 14.9291 -3.65447 11.731 +439 1 9.29105 8.34315 3.70472 21.3149 -22.535 5.81715 +440 2 10.1776 8.75859 3.73678 -10.082 3.55323 2.49013 +441 2 9.48378 7.39942 3.88081 -6.26995 14.6936 -2.40173 +442 1 17.6854 13.4687 16.4528 7.27147 30.461 -18.2669 +443 2 16.7357 13.4337 16.3398 -4.89197 -8.49248 4.47316 +444 2 17.8844 14.3284 16.0065 3.65909 -18.1112 10.9221 +445 1 5.04883 10.6547 2.58751 22.4142 -14.5409 3.1837 +446 2 5.87017 10.3468 3.04382 -22.783 5.18619 -3.79272 +447 2 4.55197 11.1441 3.22928 -6.35653 9.92745 13.9967 +448 1 3.70566 8.3683 10.3381 0.421872 -35.3081 -1.7593 +449 2 3.86061 9.29726 10.2176 3.60826 23.2513 -1.90293 +450 2 3.86652 8.14601 11.2715 -1.83662 8.64514 -7.63686 +451 1 16.1079 7.11641 6.33859 18.7251 -13.7954 -9.96454 +452 2 16.7241 7.70559 6.80408 -7.87205 -5.85527 -7.24175 +453 2 16.6678 6.33083 6.12136 -22.8952 10.0887 6.36104 +454 1 15.2027 7.00502 9.1117 -13.5711 31.2066 -33.9348 +455 2 16.009 7.42176 9.46585 -10.2898 -7.03399 -7.73296 +456 2 14.9881 7.51375 8.25647 13.8068 -20.3115 41.0185 +457 1 6.4525 13.1649 12.9201 -16.9811 1.25576 1.12717 +458 2 7.2977 12.7289 13.0561 1.55279 -4.02118 8.73008 +459 2 6.25327 13.7237 13.7059 9.12735 -9.15034 -19.1848 +460 1 12.1145 4.49786 13.0694 62.3048 41.2439 -0.723073 +461 2 12.3852 4.68406 13.9868 -14.3297 -10.0558 -0.292641 +462 2 11.3952 3.9317 13.0199 -52.2119 -35.1204 4.15665 +463 1 11.3323 8.18365 7.8522 27.7169 3.03613 12.328 +464 2 12.0901 7.73501 7.43634 -12.9205 -4.29619 -7.69129 +465 2 11.7651 8.45102 8.68662 -18.4456 -0.736999 -3.04515 +466 1 17.1666 10.776 7.42179 36.4822 -17.3878 -25.363 +467 2 17.7906 10.0723 7.08441 -17.5934 13.4566 22.3886 +468 2 17.2793 11.4524 6.73733 -15.3427 2.84073 7.18141 +469 1 5.22802 18.1471 11.05 -23.1388 -14.8798 2.48444 +470 2 4.73762 18.1049 11.901 7.4508 0.565766 -17.6495 +471 2 4.62535 17.7417 10.374 17.7336 12.8347 12.9373 +472 1 7.56653 17.6363 1.80821 4.35794 -3.26776 57.5888 +473 2 7.65741 16.7768 1.42856 9.05039 -19.6913 -22.9027 +474 2 7.35855 18.2549 1.13994 -1.37991 13.1573 -30.1972 +475 1 1.85092 12.9256 13.6076 18.7065 20.702 19.2299 +476 2 1.72104 12.4156 14.4258 -5.54537 -0.960406 -11.4426 +477 2 2.19932 13.7866 13.9501 -8.88955 -22.8153 -6.43965 +478 1 9.73868 6.79159 14.8001 -20.0718 45.6966 0.235719 +479 2 9.95236 5.95211 15.1529 12.0129 -40.6355 11.2206 +480 2 9.967 6.84408 13.8723 5.59208 -5.10263 -8.66058 +481 1 15.2087 4.3972 10.7794 -27.6923 -26.0969 -27.5028 +482 2 16.0082 3.89203 10.8637 26.1176 6.2885 5.33656 +483 2 15.2102 5.16148 11.3322 8.48984 16.211 19.3779 +484 1 11.1963 6.12482 0.150068 -21.1972 -23.7011 14.8212 +485 2 11.2381 5.20796 0.481504 11.4486 12.9471 -10.1704 +486 2 10.2374 6.21547 18.6186 14.0424 14.8346 -3.67395 +487 1 0.19533 11.3359 15.1413 -20.6703 11.3325 -28.7309 +488 2 18.4021 11.874 14.3993 9.91215 -19.3636 27.3138 +489 2 18.4481 11.661 15.9631 4.36494 9.01906 -3.16307 +490 1 7.06882 9.13032 7.26059 -19.4655 -1.24154 14.8953 +491 2 6.55985 8.40099 7.69941 12.6354 16.9737 -16.1687 +492 2 7.9725 8.82922 7.21375 8.43039 -5.65083 0.275054 +493 1 18.4578 15.4507 12.3537 3.87705 -1.0699 -4.92487 +494 2 0.776651 15.5698 12.2511 -12.7177 -2.03387 6.80581 +495 2 18.1456 15.6789 11.4721 -4.67377 -0.406651 0.743757 +496 1 16.5694 4.36967 5.25107 0.98709 -29.8421 42.9348 +497 2 16.7744 3.81151 6.06026 -19.0257 27.4778 -23.1846 +498 2 17.3898 4.32671 4.78168 15.572 7.21618 -21.1326 +499 1 17.788 3.06911 10.7078 7.64381 16.9425 17.2861 +500 2 0.075758 3.1322 11.0257 -14.4921 -2.82201 -9.29777 +501 2 17.6332 2.20749 10.3226 4.29805 -13.9207 -6.70838 +502 1 12.3142 0.064083 10.1758 -16.2036 46.6093 2.93236 +503 2 11.3746 0.384648 10.259 24.7548 -16.9496 1.0795 +504 2 12.8178 0.919304 10.3228 -10.1981 -36.9052 -8.89593 +505 1 10.3666 9.83315 12.2981 10.0643 6.74252 24.9843 +506 2 11.1015 9.85063 12.955 -7.48254 2.69098 -11.3777 +507 2 10.1328 8.91188 12.2898 -1.25875 -17.3524 -2.69444 +508 1 0.463654 2.82678 7.01839 23.1504 30.9543 10.494 +509 2 0.875324 3.58845 7.48211 -15.8261 -9.71426 -11.3384 +510 2 0.770257 2.12665 7.58365 -2.51696 -19.6875 3.88184 +511 1 0.478371 15.2358 6.91004 -5.36214 -57.1351 9.88058 +512 2 0.585298 15.6463 7.75647 2.33624 13.0536 15.0713 +513 2 0.556531 14.2524 7.18353 -2.6234 48.5984 -27.3232 +514 1 16.9534 7.00251 15.3394 -19.8576 7.98442 -8.98385 +515 2 17.6338 7.63543 15.0899 18.202 -5.57661 4.9227 +516 2 17.3093 6.19568 15.7235 12.2576 0.0838452 -6.46227 +517 1 9.0001 12.4151 8.13768 -31.7276 34.3494 27.7642 +518 2 9.37386 11.8218 7.49742 -2.69042 -17.0115 -24.8182 +519 2 8.02402 12.632 8.03373 37.271 -17.4326 -7.14384 +520 1 1.27238 1.95406 3.05803 -14.2139 -9.70678 -17.9319 +521 2 1.26084 2.61511 2.34121 0.72572 -7.36998 11.1944 +522 2 1.89031 2.22344 3.73293 7.71835 10.2015 -2.21509 +523 1 4.13907 15.1156 9.62039 -24.138 8.67184 14.727 +524 2 4.07003 15.1439 8.65747 7.76366 -2.53025 0.663124 +525 2 4.96029 14.7006 9.86457 16.019 -6.11163 -3.79055 +526 1 7.17628 2.17866 14.5671 8.05543 15.8774 -0.750343 +527 2 6.99528 1.68402 13.7698 -4.08254 -5.57585 -6.74919 +528 2 7.62131 2.98432 14.249 -3.31184 -9.11349 9.13274 +529 1 18.6082 14.7131 2.1481 32.1263 -19.3615 -2.59353 +530 2 0.838003 15.1297 2.25966 -2.55576 -5.62694 -3.02712 +531 2 17.988 15.3544 2.42675 -29.4597 23.3621 5.14018 +532 1 9.94138 2.79524 12.9422 18.0301 -20.084 -2.65944 +533 2 9.79404 2.1456 12.2228 -2.72579 10.1868 5.0837 +534 2 9.17835 3.36299 13.0326 -9.76513 7.42125 -6.32672 +535 1 2.80444 8.90955 13.0076 -21.3878 -12.6555 -0.633582 +536 2 3.06361 9.80599 12.872 11.8276 24.8177 -4.92621 +537 2 3.5122 8.48618 13.4775 16.8101 -10.8298 6.5617 +538 1 3.236 8.3574 3.63664 -3.24123 -25.7508 65.6997 +539 2 3.45085 9.0718 3.07326 14.699 31.6407 -15.7982 +540 2 3.47645 8.58669 4.60794 -10.8292 -3.55345 -46.4885 +541 1 5.62853 7.18594 8.51094 13.0444 23.9613 2.26298 +542 2 5.46784 6.31815 8.13889 -4.11832 -12.799 10.1434 +543 2 4.96415 7.47792 9.15047 -6.22666 -11.1251 -0.517113 +544 1 14.8757 1.26039 2.01768 6.89853 7.12439 -27.6668 +545 2 14.9353 2.01952 2.56559 -6.08088 15.4811 28.5729 +546 2 15.2784 1.60993 1.21235 -3.12956 -15.001 -5.59525 +547 1 8.22892 15.2012 0.850139 9.01324 -8.86779 5.43529 +548 2 9.02213 14.9338 1.33488 4.41045 13.1537 -1.08033 +549 2 7.55366 14.6663 1.27665 -10.9347 0.418265 -6.06235 +550 1 15.6387 1.34587 7.23673 -34.4855 -14.424 -6.72803 +551 2 14.9277 0.724731 6.91269 25.2779 16.6902 6.4887 +552 2 15.1173 2.1119 7.53894 8.3028 -0.775331 -5.89355 +553 1 4.90142 13.0959 18.5232 17.5611 -6.682 24.5871 +554 2 5.32755 13.082 0.76977 -9.23128 1.69535 -18.7742 +555 2 5.44764 13.7122 18.0259 4.92611 -3.73779 -6.82361 +556 1 15.3368 8.46948 18.1479 24.407 23.6523 -18.6734 +557 2 15.8061 9.12264 17.5623 -15.0725 -19.5419 9.94084 +558 2 15.3318 8.91689 0.353875 -7.67765 1.6761 7.06822 +559 1 12.0708 3.01842 18.3809 -8.57811 34.9919 -15.9288 +560 2 11.9316 2.65996 0.60646 7.37996 -15.8634 5.79137 +561 2 12.6022 2.47389 17.7995 4.55547 -17.8211 5.72515 +562 1 13.2139 12.6752 5.17768 -11.8856 9.18106 -10.9384 +563 2 13.7464 12.0348 4.69253 2.29692 -7.56952 8.05888 +564 2 13.2564 12.5123 6.11793 11.0077 -2.72782 9.02039 +565 1 6.05443 7.0356 0.031519 0.145276 -19.8641 5.27909 +566 2 5.93935 7.95118 18.5019 2.68887 36.361 -1.99394 +567 2 5.39095 6.86665 0.702638 -10.5375 -11.3291 0.555603 +568 1 17.7528 16.0276 15.0213 -26.9751 8.08167 9.65398 +569 2 16.9476 16.5457 15.105 2.62193 -2.13449 20.9775 +570 2 17.7479 16.0055 14.0813 23.0391 -15.2709 -33.7916 +571 1 13.196 0.994907 16.5363 6.64944 3.5152 15.0268 +572 2 14.1481 0.997912 16.7614 -13.0846 -5.94027 -6.50206 +573 2 12.8833 0.094199 16.7238 3.13951 3.25376 -8.62791 +574 1 11.1253 14.5647 7.20271 12.6179 20.8985 -18.374 +575 2 10.4007 14.3183 7.72981 -32.928 -10.0181 24.5345 +576 2 11.7186 13.8255 7.26943 16.9686 -3.76464 3.70387 +577 1 17.5081 8.62849 2.08107 18.4536 39.9223 21.5452 +578 2 16.6801 8.63471 2.55495 -14.8656 -12.3201 1.9096 +579 2 17.5233 7.88242 1.516 -5.44609 -31.2556 -23.2052 +580 1 12.3547 8.01168 2.02213 3.34817 7.10659 0.607451 +581 2 12.2384 8.8582 1.54611 -2.17098 -11.1853 7.9144 +582 2 11.9739 7.3152 1.48261 -5.38076 0.52639 -15.2068 +583 1 11.8761 14.6165 10.3364 1.47614 -26.5661 -12.796 +584 2 12.1004 13.7873 9.81464 -15.4397 33.1565 21.8304 +585 2 10.8993 14.6888 10.473 20.8283 -4.95583 -12.7008 +586 1 6.89524 7.05211 15.6117 0.948881 6.37495 10.6055 +587 2 7.81004 7.26536 15.3122 -15.6925 -0.985911 8.93516 +588 2 6.66676 7.54167 16.4408 13.3623 -9.35483 -24.2683 +589 1 8.00326 4.73593 13.4743 46.4542 16.9938 22.3473 +590 2 7.23337 4.7302 12.9572 -38.0428 3.58552 -28.1525 +591 2 8.40671 5.62958 13.343 -10.0413 -24.497 3.68285 +592 1 13.4128 12.1818 14.2522 -5.09814 -0.706424 13.2965 +593 2 12.9414 11.3292 14.2657 9.08717 -0.174959 -7.02282 +594 2 13.7875 12.315 13.3696 0.74786 -2.13255 -0.749325 +595 1 14.8395 9.42189 7.30548 -8.6508 -34.4179 -15.7659 +596 2 15.7087 9.765 7.42505 16.3683 18.0856 5.12693 +597 2 14.2269 10.0768 7.57319 -16.6679 19.7312 11.3719 +598 1 12.6526 17.0686 3.07252 -27.098 39.8252 10.9251 +599 2 12.8376 17.5237 3.93373 4.63929 -18.9198 -22.9156 +600 2 11.9913 17.6958 2.63477 30.4514 -31.1971 13.898 +601 1 1.15545 7.13838 17.4647 3.17244 9.59861 -23.4243 +602 2 0.330359 7.36323 17.9184 0.96629 -9.78644 0.159833 +603 2 1.05514 7.47868 16.5422 0.732192 -3.11516 17.9471 +604 1 12.7562 5.15096 15.6457 43.4314 -6.34677 13.892 +605 2 13.4512 4.55662 16.0315 -22.7809 11.2033 -14.7919 +606 2 13.2414 6.00335 15.5788 -11.6166 -6.13865 2.23982 +607 1 2.53993 3.38757 4.97618 -22.6627 40.6834 48.2045 +608 2 1.7609 3.18232 5.58922 26.9518 1.19035 -20.1247 +609 2 2.84154 4.31546 5.27885 -5.90416 -46.089 -11.2441 +610 1 8.33186 11.2983 13.4548 -26.6082 5.68838 43.1719 +611 2 8.4244 11.0562 14.4444 7.75654 0.873515 -50.9507 +612 2 8.91168 10.8786 12.8197 22.3442 -13.0535 12.4472 +613 1 12.8689 1.31514 13.3384 2.90045 58.5941 -12.9641 +614 2 13.42 1.58034 12.5659 -7.54964 -19.9936 10.3698 +615 2 12.4231 2.17844 13.5496 8.73522 -32.0886 -3.11014 +616 1 6.34008 13.7169 2.14963 -18.1698 -8.87317 18.5321 +617 2 5.63978 13.877 2.82959 15.2612 6.49493 -20.3543 +618 2 6.88351 13.0442 2.56282 10.2537 -4.17084 0.110729 +619 1 15.9206 6.61444 12.7992 -24.6515 -28.5257 0.353752 +620 2 16.3106 7.25195 12.2393 18.8127 19.5603 -18.6955 +621 2 16.4213 6.59661 13.608 8.17022 1.84551 14.3752 +622 1 16.8298 0.712824 9.59482 4.92561 -19.6459 1.56363 +623 2 16.8791 18.3713 9.72616 -6.7933 22.7031 -2.37673 +624 2 16.5452 0.8605 8.67269 -3.47063 -2.57745 5.28583 +625 1 6.14624 11.7631 8.37671 0.810232 -55.5778 6.71556 +626 2 5.32447 11.4591 8.84151 13.2611 12.3623 -11.7456 +627 2 6.64226 10.8931 8.20176 -18.8432 36.5086 0.169281 +628 1 2.88754 8.61261 0.453821 16.629 -12.4076 -25.9584 +629 2 2.45212 8.04764 18.3917 -7.9132 30.8844 23.5565 +630 2 2.34875 9.28564 0.895642 -16.9187 -4.58083 -11.1609 +631 1 10.1674 10.4623 6.50123 2.03347 0.962837 -14.0367 +632 2 10.6087 9.69731 6.89122 -0.033473 -1.16532 5.68604 +633 2 10.4694 10.4636 5.56932 -4.02396 0.831062 14.2442 +634 1 6.7142 15.6951 6.55167 21.2433 7.58031 13.0519 +635 2 7.14328 16.1838 7.27089 -7.64643 -7.38759 2.93585 +636 2 7.21237 16.006 5.79102 -10.2318 7.90387 -13.7372 +637 1 6.445 13.1807 5.57797 -4.95716 -23.6388 -1.26087 +638 2 6.7301 13.9465 6.07331 -1.77634 9.04977 6.94523 +639 2 6.09943 12.5433 6.22286 1.34041 6.33507 -0.553394 +640 1 16.8242 12.5629 9.83758 4.06472 -20.7324 4.78658 +641 2 16.9985 11.8651 9.16533 -5.27225 15.8277 3.76725 +642 2 16.5644 13.3844 9.42716 1.03985 5.07871 -11.9 +643 1 6.03738 2.95058 2.86354 -7.03855 -25.5492 -1.19629 +644 2 6.40977 3.757 2.57075 15.9289 34.7492 -4.17594 +645 2 5.57703 2.61747 2.09059 -4.9021 -9.32473 -6.53819 +646 1 10.9114 3.33767 3.30112 5.22699 -4.50477 6.26496 +647 2 10.297 4.02722 3.58926 -1.95634 -6.20434 -4.73409 +648 2 10.5127 2.84524 2.57795 -5.80356 2.60284 -4.41077 +ITEM: TIMESTEP +10 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.68613 7.08001 17.9478 -7.01358 -5.91592 2.73538 +2 2 7.77987 6.83016 18.2266 16.0785 4.58355 -9.56375 +3 2 8.81561 6.77572 17.042 -2.60158 -2.67368 4.89818 +4 1 18.5411 8.25019 6.8397 -3.31911 20.0829 53.2463 +5 2 0.132112 7.95881 5.98338 15.0803 -17.7916 -37.9407 +6 2 0.419079 7.77779 7.52768 -3.57438 0.834533 -17.4022 +7 1 8.38502 18.5543 6.8162 17.8503 9.74549 -0.663478 +8 2 9.33656 0.12202 6.71165 -15.3958 -3.25669 1.14423 +9 2 7.91896 0.595612 6.31609 0.0971505 0.0480551 2.20998 +10 1 6.59239 1.84347 11.7106 33.6248 -3.3918 -11.5419 +11 2 5.88602 2.36507 12.0365 -24.0057 14.4643 13.3031 +12 2 6.19621 1.03555 11.4016 -9.54455 -15.1367 -3.43817 +13 1 7.13469 5.75647 2.33282 -16.0707 1.2807 18.6339 +14 2 6.47472 6.10605 3.02238 22.3175 -2.25238 -34.2201 +15 2 7.09016 6.23688 1.47486 -10.0175 -2.52095 21.7818 +16 1 16.2156 10.1493 16.1334 -27.9935 4.46583 14.8083 +17 2 17.0011 10.2168 15.6173 19.2784 7.57164 -10.1711 +18 2 15.8457 11.0427 16.2776 9.29404 -6.61316 -4.9073 +19 1 10.6069 15.0238 2.30809 -6.31705 -20.7544 -7.43742 +20 2 10.5597 14.4327 3.07214 -0.102442 0.508968 4.74876 +21 2 11.0526 15.7982 2.62807 10.1844 15.1967 6.36644 +22 1 17.1594 8.2489 10.3903 7.52685 0.546464 5.9579 +23 2 16.5819 8.79937 10.9325 -0.0424193 4.91704 3.34034 +24 2 17.9857 8.74574 10.257 -6.36369 -4.03495 0.916497 +25 1 14.8922 15.8683 16.3299 23.5339 -10.8154 7.03311 +26 2 14.0097 16.1903 16.2206 -28.4756 7.26009 1.81472 +27 2 14.9055 15.3621 17.1614 -4.45807 1.9077 -0.883551 +28 1 12.1657 13.3863 0.41518 7.67499 -13.0963 13.9948 +29 2 12.1102 13.7181 18.1579 -7.06431 5.66946 -3.72811 +30 2 11.6673 13.9211 1.04936 -4.85696 8.50836 -7.81927 +31 1 9.27628 5.36844 4.05123 -34.192 4.59602 9.65195 +32 2 8.65917 5.24858 4.84371 24.3198 3.71877 -28.2857 +33 2 8.65376 5.51218 3.29446 11.8948 -3.58803 14.2972 +34 1 1.82985 4.27304 11.6494 -12.5424 24.0017 -6.14821 +35 2 1.72713 5.22025 11.9335 1.67264 -20.3932 -8.37626 +36 2 2.38183 3.84857 12.2925 10.2742 -10.1374 14.5925 +37 1 1.96666 6.8371 8.3675 -1.07206 -9.37897 -7.64517 +38 2 2.48137 7.16021 9.09528 7.6819 14.0614 11.7347 +39 2 1.91994 5.89719 8.57067 -2.65468 -6.85216 -5.3032 +40 1 5.40566 4.39875 7.93795 -15.0212 -10.7202 -17.6012 +41 2 5.47911 3.43644 7.82861 5.00513 7.47325 10.3929 +42 2 4.74947 4.60653 7.2496 8.53973 6.88839 10.8311 +43 1 3.24286 2.9209 17.5475 -3.50993 31.6723 15.8788 +44 2 3.91538 3.33593 16.9792 1.14815 -4.85754 -1.50754 +45 2 2.90196 3.68515 18.1088 4.46159 -27.603 -16.229 +46 1 7.46543 5.27113 6.11173 -0.267366 -14.8618 42.036 +47 2 7.89952 5.61794 6.92737 -2.28349 10.3868 -28.0837 +48 2 7.00366 4.5014 6.50229 0.780861 12.0869 -17.1147 +49 1 9.7753 7.01959 11.9799 12.4421 -0.327694 33.7281 +50 2 10.3285 6.37932 11.5448 5.34489 -7.46932 -11.0014 +51 2 9.14168 7.33293 11.3548 -18.5265 5.10994 -23.2436 +52 1 14.1114 3.54906 8.03925 -21.2079 2.70274 -24.764 +53 2 13.5379 4.24737 7.67406 9.42135 -8.95765 0.532077 +54 2 14.4057 3.90023 8.85862 11.8721 11.0917 26.6467 +55 1 4.80077 17.263 4.02669 -14.2573 4.92943 -10.2324 +56 2 5.55275 17.8868 4.11075 -15.7048 -9.31229 -6.31173 +57 2 4.21849 17.485 3.25536 16.798 3.03083 13.1086 +58 1 16.5008 16.6241 10.052 9.35033 0.377019 -20.0251 +59 2 16.0742 16.3966 10.8515 -13.0635 -0.25069 32.9814 +60 2 15.9476 16.1716 9.40786 2.84148 0.00630379 -7.36632 +61 1 1.95698 4.92664 0.48601 10.6785 6.17321 -0.923017 +62 2 2.54546 5.28332 1.19783 -10.1544 -3.94981 -19.1082 +63 2 1.86706 5.64777 18.4726 -0.259245 -4.73099 10.3692 +64 1 11.8035 13.3621 16.2801 -12.0315 -31.2076 -16.8087 +65 2 11.3006 12.5351 16.4295 -1.37085 13.2186 10.8936 +66 2 12.2283 13.1244 15.4353 5.36339 15.8055 8.10642 +67 1 10.1086 11.0623 16.95 16.2363 -23.6439 1.11167 +68 2 10.572 10.1938 17.105 -14.3776 22.5927 -6.24497 +69 2 9.21542 10.8357 16.6616 -0.160324 -0.0991661 2.29857 +70 1 11.7231 17.5369 13.4667 -11.0418 -25.624 2.08744 +71 2 12.2825 16.9797 12.896 1.06573 10.1819 1.6514 +72 2 12.0497 18.4302 13.3866 8.679 12.3703 -3.21063 +73 1 6.34404 9.31427 12.2267 -10.7289 -25.2447 -16.4149 +74 2 6.95388 8.98312 11.5319 -2.39052 10.1346 10.7157 +75 2 6.76108 10.0063 12.722 17.2241 14.9443 4.4156 +76 1 16.2191 12.7237 2.7003 -6.42998 -13.8373 4.3175 +77 2 16.9936 13.1939 2.44509 26.0904 7.71252 -7.79508 +78 2 15.5637 13.4111 2.72948 -20.2851 11.8065 3.04981 +79 1 0.635855 12.5646 5.86231 -29.6975 10.9384 -12.0161 +80 2 0.906184 12.4779 4.92975 2.15237 -1.21985 12.1118 +81 2 18.3245 12.8391 5.75844 29.6273 -11.2198 7.31028 +82 1 5.19222 16.3868 18.4948 24.5889 -0.529385 -6.85369 +83 2 5.88953 15.8781 18.0466 -13.534 -2.69513 -2.10794 +84 2 5.71609 16.8872 0.480999 -10.5805 4.6302 6.45748 +85 1 0.515864 7.62939 4.0653 41.0474 19.9956 -23.6294 +86 2 18.5677 8.05158 3.40199 9.2753 -7.28591 11.0746 +87 2 1.47269 7.84683 3.73678 -46.4137 -9.00167 19.6367 +88 1 3.14217 8.89553 6.52533 -39.0459 6.50689 -6.5056 +89 2 3.57285 8.63007 7.33767 0.0694837 -1.26665 5.56399 +90 2 2.14756 8.93745 6.67407 38.5311 -3.64433 -0.906695 +91 1 7.31414 10.3036 16.1763 -22.1518 3.21861 21.8391 +92 2 6.53268 10.4772 15.6415 8.43374 -0.0418936 -5.11234 +93 2 6.92709 10.2964 17.0866 13.3044 -2.27208 -10.5118 +94 1 11.1096 1.06093 5.00144 -6.80657 -2.48033 -19.8934 +95 2 11.1672 1.90146 4.5306 6.84499 7.0717 9.43568 +96 2 10.7236 0.515071 4.29558 2.64862 -9.02148 12.7331 +97 1 4.44354 2.70015 13.2121 -7.85281 -5.62302 -11.5877 +98 2 4.59136 3.20795 14.0303 0.103412 -15.4758 0.294405 +99 2 4.3686 1.71349 13.3622 2.85998 26.6352 12.1157 +100 1 8.41457 10.0307 1.78829 1.66015 -12.4273 17.1623 +101 2 8.40835 10.6665 2.53096 -1.47245 -0.417386 -5.09881 +102 2 8.60407 9.1525 2.20287 -3.10051 22.5249 -10.5265 +103 1 10.5229 1.75436 15.5533 -10.8574 -2.31 -4.36647 +104 2 11.4367 1.69676 15.8141 13.1269 -3.82494 7.61076 +105 2 10.5487 1.84704 14.5957 -9.26118 2.80358 -1.94415 +106 1 2.76968 12.9399 7.75003 -7.62511 -10.5749 7.18171 +107 2 3.32023 13.5874 7.29614 -2.30989 2.01815 -3.81018 +108 2 2.03946 12.7099 7.15165 5.79412 3.19458 -2.23462 +109 1 3.64251 11.6901 5.3273 -16.0178 -10.9709 -3.95767 +110 2 3.35804 11.041 6.0007 8.31372 10.277 -11.7948 +111 2 2.86611 11.8409 4.75105 13.6859 -0.281218 5.78901 +112 1 6.88155 14.4797 16.8524 -8.387 2.95998 -0.938339 +113 2 7.57426 13.8507 16.6622 5.60788 -2.76391 3.60002 +114 2 6.54738 14.7428 15.9834 -3.14908 -1.19839 3.78249 +115 1 14.1759 14.5423 3.40785 14.1775 -0.803279 -11.9449 +116 2 13.6583 15.316 3.2037 -5.78511 13.0134 -4.56688 +117 2 13.7723 14.1777 4.18517 -7.95121 -12.1195 11.7606 +118 1 8.26975 18.1784 16.0718 57.0984 -9.85256 5.13508 +119 2 8.90468 17.4721 16.3223 -30.0265 -6.05197 -2.08742 +120 2 8.93252 0.246004 16.0158 -21.102 13.2242 -8.22396 +121 1 4.73201 1.6168 4.90814 8.59128 29.3629 -19.7592 +122 2 3.91099 2.13549 5.04668 12.4977 -9.17326 -4.88478 +123 2 5.26431 2.14928 4.23236 -22.3039 -21.7635 28.9569 +124 1 15.1182 12.8405 16.4381 19.169 -3.61406 36.631 +125 2 14.6612 12.9963 17.2965 -1.87916 -0.605635 -21.6052 +126 2 14.5331 12.7051 15.7087 -30.2626 -2.71441 -16.8094 +127 1 15.786 18.3864 16.793 25.1295 13.8681 33.7963 +128 2 16.4578 18.6099 17.5315 -31.6416 -14.5347 -31.3905 +129 2 15.6162 17.4305 16.8164 1.02724 4.80811 3.46398 +130 1 1.14089 1.13731 16.5539 1.05247 19.7088 19.8175 +131 2 1.92337 1.60495 16.9036 -3.97271 -4.80748 -10.3705 +132 2 0.461096 1.48073 17.164 6.66439 -11.1518 -10.5802 +133 1 18.0862 4.58432 15.8734 11.1688 -12.2484 -2.69667 +134 2 18.5694 3.95442 15.2994 -8.21946 11.4291 8.6944 +135 2 18.5872 4.69164 16.6898 0.203498 -2.64567 -2.95902 +136 1 12.2303 16.9505 16.1288 -38.2728 -13.2591 26.8237 +137 2 11.3888 16.5791 16.5378 36.1694 7.82178 -3.50336 +138 2 11.9114 17.1502 15.2549 6.78701 5.10115 -22.4581 +139 1 15.8814 2.54765 17.9709 5.97775 7.55467 -0.319093 +140 2 15.7733 3.43717 18.3784 -1.8513 -17.3861 -11.5789 +141 2 15.6471 2.5946 17.0126 2.53833 6.86428 19.1803 +142 1 6.70799 13.8021 10.253 -1.58408 1.43394 8.76454 +143 2 6.59288 13.5189 11.1728 1.36627 8.87991 1.27306 +144 2 6.58321 12.9942 9.75946 1.30239 -6.02422 -13.3165 +145 1 10.1413 18.2148 2.80353 9.44086 30.3012 -19.3156 +146 2 10.2266 0.305071 2.14691 0.267733 -14.8877 14.3982 +147 2 9.27777 17.8669 2.60695 -13.096 -6.5965 0.845742 +148 1 2.97176 17.7529 6.06326 -6.30899 -0.645097 35.0899 +149 2 2.08427 17.6133 5.69483 9.57331 2.68214 -12.771 +150 2 3.63239 17.8017 5.37586 1.28926 -2.69105 -18.2517 +151 1 12.5668 16.9974 7.96757 -20.2971 -18.5655 21.3419 +152 2 11.8856 16.2971 7.95074 9.26888 3.31932 -10.856 +153 2 12.3344 17.4798 8.78306 11.437 7.92329 -7.28752 +154 1 14.8861 15.2795 8.28974 -15.7554 0.3814 10.2226 +155 2 14.0374 15.7294 8.25106 -5.80199 2.88483 11.5438 +156 2 15.1981 15.4683 7.42207 26.2963 -2.4275 -26.3232 +157 1 17.5473 18.3112 0.374559 -18.2134 -6.45531 -4.6775 +158 2 18.2634 17.761 0.12213 22.8374 -25.4457 -15.3465 +159 2 17.9951 0.303427 0.894204 5.3706 29.2695 18.8411 +160 1 0.910079 10.3754 1.4141 -19.386 -45.7403 28.0244 +161 2 0.0926857 9.86966 1.69283 27.9138 11.9581 -5.7438 +162 2 0.554372 11.07 0.90565 -10.4877 37.4892 -28.5805 +163 1 1.56425 12.1843 3.32385 10.4497 17.8757 14.7846 +164 2 1.39557 11.5297 2.67534 -6.58566 -33.3087 -13.0061 +165 2 1.62643 12.9551 2.76927 3.66066 18.4363 0.784965 +166 1 0.55148 17.2559 4.87768 14.7947 16.704 -22.83 +167 2 -0.0171494 17.9122 5.24737 -12.9669 22.3753 -0.718336 +168 2 0.416337 16.5086 5.40997 -1.38762 -39.6682 22.4532 +169 1 1.10468 1.00284 9.3945 22.843 10.0615 -6.85845 +170 2 1.39907 0.698807 10.2625 -7.65597 -6.79115 6.92044 +171 2 0.213465 0.701839 9.27091 -15.6194 -8.53979 4.03703 +172 1 16.7947 2.33154 13.2859 2.87858 8.18604 -25.1476 +173 2 17.0129 2.55787 12.3417 -6.42954 -5.0835 25.2497 +174 2 16.4749 1.41822 13.3005 0.0523867 -3.46078 1.59731 +175 1 2.46566 15.827 12.1934 26.7468 -10.5365 13.2985 +176 2 2.93451 15.5288 13.0073 -9.90545 6.65681 -19.023 +177 2 2.95128 15.4495 11.4346 -3.9234 5.36807 1.6728 +178 1 16.4371 15.5461 5.94503 -4.66267 19.6238 -8.97399 +179 2 17.3612 15.5093 6.28134 -9.63254 6.93473 -7.38316 +180 2 16.3109 16.2991 5.29174 10.2179 -16.1602 20.4085 +181 1 5.84392 5.02209 11.7979 1.85982 -4.44524 -6.98506 +182 2 5.51366 5.87933 12.041 -2.35542 15.5447 8.97079 +183 2 5.10963 4.44446 12.0068 -1.26359 -10.5886 0.396425 +184 1 15.2223 4.8645 0.724291 -23.0156 -11.391 23.7803 +185 2 14.7624 4.52384 1.55825 21.1304 12.2284 -22.5635 +186 2 14.5125 5.05103 18.7394 0.751055 2.39009 4.23042 +187 1 16.343 16.2984 2.11648 10.3227 5.9227 -27.7144 +188 2 16.0112 16.8052 2.83865 -11.2354 10.0489 28.078 +189 2 16.6417 17.0002 1.51324 -1.84363 -9.29214 0.277829 +190 1 0.300695 4.8777 3.79796 -11.7144 38.8206 3.66766 +191 2 0.319109 5.88664 3.94702 6.24107 -45.2605 -6.61048 +192 2 1.15751 4.50056 4.01017 2.49534 2.82459 2.96224 +193 1 2.92353 14.9884 15.0405 10.7548 -7.33568 16.7257 +194 2 2.98085 14.609 15.9661 -8.47597 15.0336 -19.5599 +195 2 2.47925 15.8529 15.1074 -0.728265 -0.613609 8.13891 +196 1 1.11951 14.5697 9.5576 17.0302 46.4745 -20.2694 +197 2 2.08903 14.5584 9.38425 -20.4257 -12.3501 8.75388 +198 2 0.805573 13.7616 9.91809 5.52927 -28.6811 10.8766 +199 1 13.6617 16.6633 11.5459 -10.7506 10.3565 -21.4971 +200 2 13.3218 17.4276 11.0158 5.92664 -14.8533 17.3679 +201 2 13.3915 15.8986 11.0154 -3.11899 -0.859159 7.39997 +202 1 4.73366 1.47986 0.719369 -25.3145 -4.02421 3.51446 +203 2 4.15092 1.98399 0.125941 8.58395 1.79335 0.854136 +204 2 4.09918 0.853913 1.13528 12.7275 2.9151 -0.0185569 +205 1 1.42442 18.4742 11.9045 -6.93945 20.4545 -13.991 +206 2 1.2372 0.390371 12.6666 -0.822965 2.19478 3.53324 +207 2 1.89543 17.725 12.2367 7.95706 -17.4489 5.30436 +208 1 11.5469 10.1058 4.11116 26.1716 14.4711 -26.2735 +209 2 11.5284 10.5631 3.21886 -3.69376 -13.1884 23.9867 +210 2 12.5118 10.0773 4.36205 -26.1062 -0.534026 -7.20275 +211 1 8.37237 12.1712 3.75254 -13.3709 24.5961 46.1376 +212 2 9.17249 12.5936 4.11701 3.41223 -8.92861 -19.033 +213 2 7.75234 12.4533 4.48752 5.20668 -18.7884 -32.053 +214 1 14.3233 4.03204 3.29282 11.0049 6.10018 19.4579 +215 2 14.9517 4.19348 4.04461 -8.72763 -4.53117 -18.7735 +216 2 13.4979 4.46304 3.56838 3.12416 -1.49393 -3.31976 +217 1 5.58139 1.77074 7.50691 -36.613 -47.7339 30.604 +218 2 4.96189 1.1025 8.02564 35.7201 38.4984 -27.3817 +219 2 5.38779 1.57566 6.57729 1.13697 3.96791 -6.02851 +220 1 17.9042 1.1171 4.88471 6.84957 17.1887 -7.45832 +221 2 18.4571 1.56865 4.21188 -4.6905 -14.0516 5.22121 +222 2 17.737 1.81424 5.53024 -1.96776 -6.02251 3.4729 +223 1 6.82733 9.39684 4.48845 1.87187 -0.890058 -10.0607 +224 2 6.84716 9.53076 5.42818 -7.08772 5.76802 18.8049 +225 2 7.72364 9.08838 4.32443 4.93667 -1.85919 -9.57362 +226 1 2.70107 14.964 1.9632 9.79064 -8.50271 -23.1477 +227 2 3.33865 14.7342 2.63816 0.0868029 -0.794049 11.9475 +228 2 3.17782 14.7454 1.13419 -13.4 8.87294 12.5953 +229 1 17.2782 12.8964 13.1387 8.1593 -36.3772 6.82198 +230 2 16.3556 13.1177 13.3173 4.03584 18.7537 -2.31465 +231 2 17.8303 13.6552 12.9439 -8.38561 20.0322 -1.78655 +232 1 15.018 10.5797 1.38541 -30.6488 -33.8734 -22.7761 +233 2 15.5405 11.2097 1.82354 25.6355 33.1541 21.1587 +234 2 14.2986 11.0703 0.97193 1.92599 -0.723232 4.24038 +235 1 5.71261 6.94641 4.5266 2.6516 -23.4686 10.5302 +236 2 5.87991 7.88124 4.41392 4.1014 10.4162 -0.896017 +237 2 6.40034 6.62744 5.14459 -6.91809 0.316355 -6.72793 +238 1 8.10894 8.26231 10.1757 -1.61977 4.99166 17.0229 +239 2 8.63366 8.87039 9.65704 12.8257 12.1371 2.09156 +240 2 7.5873 7.82886 9.51802 -16.026 -14.2044 -11.4362 +241 1 13.5265 18.2929 5.80397 -22.7677 -1.43199 15.791 +242 2 12.744 0.210577 5.63003 6.52185 -0.137688 -2.34328 +243 2 13.224 17.7307 6.55929 8.82644 11.7072 -16.2211 +244 1 0.31998 2.55606 0.111337 -23.7151 48.4906 1.53453 +245 2 18.006 2.70756 18.6319 7.21623 -15.3908 0.76394 +246 2 0.639493 3.49242 0.214062 7.71863 -30.3236 1.31164 +247 1 12.6438 10.9651 9.76843 -27.6007 42.776 -15.0826 +248 2 11.6462 10.8587 9.68427 36.5826 -6.8361 3.61513 +249 2 13.0097 10.1328 10.024 -0.792921 -29.0746 6.76076 +250 1 0.78357 12.2825 11.0843 20.7577 -6.91251 -2.74458 +251 2 18.4749 12.2741 11.1385 -12.0685 2.84404 7.0736 +252 2 1.15918 12.6384 11.9096 -11.1326 -3.84191 -3.75479 +253 1 5.04379 7.22322 13.4829 1.39832 5.89977 -6.97466 +254 2 5.58123 7.93479 13.1271 0.448534 7.96016 -10.0051 +255 2 5.53384 7.00565 14.2746 1.03136 -7.66768 11.7435 +256 1 1.27874 6.97532 11.834 -32.074 -43.2189 -14.0481 +257 2 0.482678 7.18669 11.3131 10.1443 0.561183 6.98996 +258 2 1.70367 7.78255 12.0103 18.1825 36.8435 9.31001 +259 1 15.4541 9.47267 12.3132 5.88964 23.7827 6.22024 +260 2 15.5166 10.4677 12.3686 -5.40153 -30.7713 4.20372 +261 2 15.4815 9.07432 13.2056 -1.6395 12.2138 -11.1334 +262 1 16.6425 12.9485 5.45228 -24.7761 13.2233 -32.5849 +263 2 16.3124 13.8685 5.42836 11.1894 -7.98651 20.9726 +264 2 16.4187 12.7313 4.52305 11.1313 -16.3356 15.5726 +265 1 6.1733 10.0557 0.193027 -12.4899 -11.5053 -32.3049 +266 2 5.38495 10.4604 0.58061 6.43577 -0.470902 4.897 +267 2 6.88008 10.1049 0.827544 12.5305 3.42311 14.2724 +268 1 12.3659 6.05415 4.04188 -22.1763 -21.8278 15.5685 +269 2 12.3683 6.79715 3.46108 4.13216 24.0909 -16.7914 +270 2 11.421 5.79287 4.05326 15.4186 -0.211849 3.77561 +271 1 0.132582 12.8231 0.203992 -0.195483 1.63508 -4.90635 +272 2 -0.0245094 13.5503 0.825031 2.49545 -1.98409 0.771993 +273 2 18.2458 13.055 18.0666 5.13636 -1.5464 3.82803 +274 1 3.83888 18.5816 8.61379 -9.81831 -4.88162 -16.6552 +275 2 3.52001 18.2631 7.75085 8.43173 -4.7192 1.01067 +276 2 3.03206 0.305129 8.96677 -7.80256 7.43459 9.99927 +277 1 7.39556 17.2738 4.45596 16.9172 12.0122 12.5371 +278 2 7.99849 17.9848 4.79149 -15.6229 -16.9846 -19.2965 +279 2 7.33818 17.3251 3.48629 6.36463 5.57381 8.87833 +280 1 9.21998 17.0388 12.2284 15.8258 3.83046 11.207 +281 2 9.35195 16.1931 11.7423 2.16771 12.8413 7.7779 +282 2 10.0104 17.2216 12.8137 -16.5375 -11.854 -19.0408 +283 1 13.3184 13.0063 7.94019 -19.3301 -32.807 5.85066 +284 2 13.1883 12.2647 8.56801 -4.60418 3.91603 -7.64254 +285 2 14.1459 13.3708 8.19821 21.3317 21.1541 5.11013 +286 1 14.9844 2.95035 15.3504 8.07249 -1.73557 -24.8008 +287 2 14.3 2.40675 14.9389 -0.805511 -1.63288 7.60525 +288 2 15.6705 2.98762 14.6436 -9.05507 2.69068 16.8604 +289 1 9.85476 15.5033 17.004 5.70996 8.22456 -10.0233 +290 2 10.2769 14.6753 16.7296 0.407564 1.12786 2.5917 +291 2 9.2992 15.3275 17.7693 -4.49302 -4.18434 5.79618 +292 1 11.2887 8.25054 16.5462 4.3815 15.8935 1.4126 +293 2 10.7498 7.72178 15.9677 -11.4268 -3.01506 -11.0903 +294 2 11.7109 7.60541 17.1026 7.03572 -6.39426 11.2088 +295 1 3.78312 18.1923 16.7229 -8.20319 16.8802 -14.09 +296 2 4.23544 17.5706 17.2928 8.99584 -2.65396 14.876 +297 2 3.78517 0.451969 17.0887 5.65759 -16.2586 2.71634 +298 1 2.1977 4.10819 8.95021 24.5715 -13.8141 31.6135 +299 2 3.03624 3.61916 8.82088 -15.7399 12.2693 -11.2697 +300 2 2.14197 4.07166 9.94067 -11.3718 7.67499 -23.2123 +301 1 9.90974 10.3516 9.73776 -22.8793 37.5197 3.40937 +302 2 9.44348 11.1923 9.4561 16.1923 -27.4723 -0.755713 +303 2 9.93951 10.4177 10.7077 4.76489 -7.47333 -8.73237 +304 1 9.73601 0.810068 10.8572 -6.50885 -0.835519 -1.39877 +305 2 9.40585 18.6129 11.1735 2.22486 -11.7661 13.7712 +306 2 9.0915 1.01857 10.1847 -1.93261 14.5334 -11.6688 +307 1 9.19364 15.2092 10.2107 -23.0073 -10.2994 -8.74256 +308 2 8.9841 16.0542 9.76587 1.98806 -14.8547 5.4661 +309 2 8.35152 14.6762 10.1166 22.3916 12.2872 5.93767 +310 1 0.995532 9.29186 10.3281 47.9462 -2.63812 -8.64675 +311 2 1.22741 10.2031 10.5086 -13.3799 15.5027 2.96196 +312 2 1.9063 8.9262 10.1621 -35.7029 0.949407 3.82346 +313 1 16.813 4.88766 8.1932 11.5161 -10.5322 32.9144 +314 2 16.1615 5.34773 8.77307 11.8935 -6.11126 -18.0819 +315 2 17.4051 4.37395 8.80041 -19.6267 13.8505 -17.9411 +316 1 14.6429 14.6942 0.394535 -7.00543 -1.89626 8.24203 +317 2 15.0463 15.2494 1.09531 -2.64327 -9.316 -7.76003 +318 2 13.8679 14.2346 0.794348 15.878 11.3494 -8.58286 +319 1 3.51953 11.0524 9.63262 1.11689 7.20138 -8.56155 +320 2 3.49309 11.4422 10.5196 2.01858 0.130954 -3.30783 +321 2 3.17116 11.7397 9.0203 2.67149 -7.88535 6.47818 +322 1 11.039 10.8616 1.27104 8.39953 16.0658 -8.46941 +323 2 11.1885 11.6907 0.750788 0.782166 -19.893 14.3131 +324 2 10.1072 10.6419 1.14889 -0.773464 -1.49716 1.06219 +325 1 13.2204 7.07184 12.8933 -24.0174 5.01566 -6.09093 +326 2 14.1394 6.83939 12.9167 20.0602 -3.76028 0.39046 +327 2 12.7464 6.22555 12.8749 2.49778 2.97258 -0.29329 +328 1 9.62856 1.88969 0.946546 9.2636 -0.931103 20.1878 +329 2 8.76541 2.02695 0.593353 -22.3319 -0.80038 -4.92587 +330 2 10.1675 1.74594 0.181071 13.2226 0.132969 -11.6901 +331 1 10.5934 13.5316 4.73807 16.1446 0.574492 13.3086 +332 2 11.4317 13.0614 4.94174 -10.7106 3.3069 -14.0299 +333 2 10.5321 14.1207 5.51129 -4.24994 -4.20037 -10.3127 +334 1 14.2715 1.70318 10.8964 -1.77809 5.91235 7.28652 +335 2 15.0728 1.25501 10.5853 5.24738 9.35157 -1.74174 +336 2 14.4034 2.67095 10.8772 7.32957 -6.49183 -2.39775 +337 1 14.6603 12.4192 11.7243 1.91159 -25.2344 -56.6412 +338 2 15.4845 12.4874 11.1931 -4.23005 7.1619 22.5795 +339 2 14.0903 12.0081 11.0211 -1.48986 11.1607 31.5891 +340 1 8.24886 5.08654 9.79134 -29.2123 3.64284 23.7692 +341 2 7.42109 5.02927 10.3149 15.0309 17.1198 -4.03621 +342 2 8.23121 4.21184 9.43797 12.1669 -22.8524 -17.3047 +343 1 1.59528 16.8201 18.3251 -4.66834 32.7155 -7.23976 +344 2 1.93304 17.2062 17.488 -5.12416 -8.69561 13.5025 +345 2 1.82608 15.9028 18.3034 8.21551 -19.1337 -3.40609 +346 1 1.44054 17.2474 15.3375 38.2305 -7.16391 -6.50211 +347 2 1.35107 18.1379 15.6308 4.79859 24.8425 9.12518 +348 2 0.562777 16.9452 15.3387 -39.5261 -18.284 -3.02502 +349 1 3.72855 5.57524 6.20331 -9.94128 10.6794 2.05156 +350 2 3.21297 6.20603 6.76334 9.83918 -6.42931 -13.7589 +351 2 4.29894 6.06824 5.5848 -3.89827 7.08279 4.15512 +352 1 12.3545 9.42683 14.1827 20.4014 -41.9092 8.4814 +353 2 12.8623 8.59837 13.88 -21.4785 35.8512 3.66034 +354 2 12.0611 9.1345 15.077 2.36507 11.6403 -12.9904 +355 1 4.03327 15.2744 6.905 24.5442 3.45717 -5.69457 +356 2 3.46314 16.0225 6.67296 5.01039 2.15408 -3.12402 +357 2 4.97164 15.5268 6.67147 -27.9532 -4.4537 7.17357 +358 1 0.606997 8.56433 14.8637 1.00605 -0.185347 4.59471 +359 2 0.51054 9.52697 15.0006 4.18475 -5.95105 -3.81642 +360 2 1.25745 8.45601 14.1476 -5.10421 5.72757 5.73964 +361 1 12.9756 8.36618 10.3398 20.3701 -17.1189 -10.5242 +362 2 13.727 7.8435 10.0036 -6.14808 8.99881 -11.6124 +363 2 12.9675 8.02293 11.2263 -11.3517 2.56625 21.5008 +364 1 15.2884 7.63693 3.49378 10.1588 18.7913 -12.1111 +365 2 14.5458 7.1482 3.08376 7.93209 -0.245397 21.6039 +366 2 15.5211 7.50792 4.43838 -15.1505 -14.5868 -6.72816 +367 1 17.3202 6.64717 0.0328861 -29.9623 13.6257 -2.83905 +368 2 16.7745 5.97673 0.482414 9.93705 -0.647346 -3.81794 +369 2 16.6178 7.22121 18.2734 18.8696 -9.84661 9.86066 +370 1 8.80495 6.92785 7.84504 -31.0915 -18.6038 9.28479 +371 2 9.6769 7.2872 7.80779 30.3288 7.87046 2.96903 +372 2 8.72406 6.35246 8.64105 6.6093 9.83872 -10.9319 +373 1 12.3211 0.614363 1.17365 13.0662 -3.77868 -0.487657 +374 2 13.0766 0.983141 1.64654 -0.239842 1.32967 3.5541 +375 2 12.751 18.5673 0.657414 -10.2946 0.778432 -2.83622 +376 1 5.67951 15.1028 14.5131 10.9467 16.6442 -3.65569 +377 2 4.71936 15.1727 14.6088 -3.18386 3.297 0.861488 +378 2 6.03308 15.9436 14.1233 -11.409 -15.106 9.73801 +379 1 3.83531 6.52602 1.68735 -5.34791 11.2881 1.09554 +380 2 3.46655 7.33088 1.27913 5.03876 -12.3281 -3.02901 +381 2 3.83759 6.80671 2.60341 5.67562 -6.55284 8.9174 +382 1 3.89065 11.6139 12.2421 9.17745 -10.34 -2.42323 +383 2 4.7546 12.041 12.3761 -4.43478 1.7756 4.32079 +384 2 3.22616 12.1252 12.7041 -4.55935 10.4369 8.15325 +385 1 5.44913 3.8771 15.872 6.89679 52.3696 13.3559 +386 2 6.00532 3.19945 15.5174 15.3476 -19.3003 -7.67953 +387 2 6.04432 4.69577 15.9682 -27.8341 -34.2187 -5.04159 +388 1 14.46 10.319 4.39654 9.99722 -28.3378 -34.0856 +389 2 14.8446 9.82936 5.13517 -3.65574 0.244774 4.37558 +390 2 14.7053 9.78242 3.56924 -11.9433 24.8074 33.8136 +391 1 7.944 17.2975 9.23787 -28.0002 30.4191 -3.50914 +392 2 7.19679 17.6006 9.79194 10.1387 -11.5361 -1.79961 +393 2 7.93806 17.9436 8.50883 9.12371 -8.84918 -0.989999 +394 1 4.50274 14.4265 3.96251 25.8442 16.5744 44.5421 +395 2 4.82189 15.3364 4.24204 -15.9069 -22.6382 -13.9696 +396 2 4.78076 13.8411 4.72747 -13.1976 12.376 -28.3375 +397 1 14.3227 7.38582 15.7589 14.6846 6.74467 9.8564 +398 2 15.2487 7.24382 15.4614 -20.8339 3.06086 7.28672 +399 2 14.432 7.78597 16.648 -5.3607 -7.66211 -14.83 +400 1 2.87305 18.2228 1.9038 16.9424 31.4889 37.3817 +401 2 2.5254 17.6641 1.24513 -20.0746 -27.9737 -30.7942 +402 2 2.12041 18.5329 2.44243 8.04928 -1.15784 -8.26421 +403 1 7.96513 1.6038 4.534 28.375 12.0389 1.8382 +404 2 7.4881 1.94169 3.78174 -16.4915 0.831655 -6.1583 +405 2 8.81315 2.08427 4.47067 -11.0504 -12.9149 7.37414 +406 1 2.66628 14.1304 17.7551 -36.5802 -20.3813 5.76686 +407 2 1.82799 13.6385 18.0009 26.1666 13.51 -7.41699 +408 2 3.38829 13.5766 18.1016 -3.21353 7.84202 -3.40779 +409 1 0.72398 1.68558 13.861 19.6061 1.62564 -3.20216 +410 2 0.832024 1.51571 14.7895 8.81281 -5.19825 13.648 +411 2 18.448 1.87896 13.7961 -22.7247 6.41229 -8.76432 +412 1 4.5528 18.6039 13.9643 16.282 -5.93943 -10.6264 +413 2 5.43228 18.1791 13.8337 -18.6035 11.3559 2.42201 +414 2 4.30609 18.3878 14.8696 -5.35687 -0.29015 4.72759 +415 1 7.10471 0.475722 18.3652 -9.95344 30.3778 33.8159 +416 2 7.09526 0.10374 17.5021 -2.11792 -9.18089 -28.9852 +417 2 6.24907 0.928295 18.5508 11.5399 -12.8337 -6.73806 +418 1 16.1003 18.4419 14.1295 -36.1288 -26.1963 -8.72431 +419 2 15.3858 17.8107 13.8537 25.0074 20.4613 -2.43664 +420 2 15.9155 18.5409 15.0697 10.6475 8.10349 1.05551 +421 1 10.1087 4.51964 16.2872 -49.6317 2.46368 -20.184 +422 2 10.9899 4.47274 16.5903 35.3659 -6.27505 9.52333 +423 2 9.84839 3.65208 15.9265 12.032 5.89647 9.33422 +424 1 15.84 17.9245 4.41355 -16.3771 8.07859 19.8211 +425 2 16.4973 18.6399 4.5293 -6.75294 -6.64677 -2.2152 +426 2 15.0245 18.216 4.92863 29.2279 -12.5546 -21.8691 +427 1 6.93052 17.3604 13.733 43.7573 11.6301 8.94285 +428 2 7.46287 17.7112 14.5144 -20.3873 -12.0805 -21.5216 +429 2 7.61723 17.2481 13.0216 -16.2109 2.19972 16.1164 +430 1 13.284 6.56612 6.73549 -17.3988 -10.9235 -13.9284 +431 2 14.2147 6.66272 6.66556 31.8926 9.42178 10.838 +432 2 13.0817 6.39483 5.81333 -16.4457 -2.73061 -4.18006 +433 1 7.68008 2.38704 9.18412 -10.173 -8.0052 -21.8631 +434 2 7.24249 2.31281 10.0234 -2.88588 -0.126179 20.3224 +435 2 6.98126 2.1061 8.54708 21.029 6.80491 7.05088 +436 1 15.1532 14.8723 13.6487 -17.4978 4.30428 5.82091 +437 2 15.0143 15.0659 14.5909 6.59258 -1.67926 -7.31154 +438 2 14.3234 15.1254 13.2077 14.4343 -4.04757 1.78875 +439 1 9.30028 8.33456 3.70705 10.2977 -8.98362 5.75949 +440 2 10.1463 8.82212 3.80538 -6.03443 -8.47657 3.00821 +441 2 9.47356 7.38745 3.89392 -0.00834887 14.0135 -2.32863 +442 1 17.6906 13.477 16.4461 19.9282 13.2905 -5.82842 +443 2 16.7369 13.3711 16.3792 -1.87427 5.41308 -4.03884 +444 2 17.9311 14.3351 16.016 -12.453 -14.9372 6.18952 +445 1 5.04349 10.6567 2.59903 16.1191 -13.6813 18.2195 +446 2 5.79495 10.2927 3.12129 -13.5181 3.52014 -12.0414 +447 2 4.57705 11.1773 3.24438 -8.0447 10.2459 5.04269 +448 1 3.70971 8.35842 10.3252 1.44092 -18.6834 3.58878 +449 2 3.85247 9.29033 10.1825 3.16815 17.7869 -8.4001 +450 2 3.85129 8.23256 11.2753 -2.11366 -0.888936 -6.9574 +451 1 16.1019 7.11228 6.32302 5.1556 -18.0856 -12.5793 +452 2 16.7603 7.67894 6.76117 -3.13697 -10.0137 -6.06994 +453 2 16.5199 6.22503 6.17941 -9.70023 19.4355 5.8489 +454 1 15.1873 7.00993 9.1119 -0.598311 32.9952 -33.7165 +455 2 16.0219 7.38603 9.44635 -11.3494 -6.74009 0.758637 +456 2 15.0255 7.54922 8.27157 3.37955 -23.1281 33.9738 +457 1 6.44391 13.1496 12.9059 -4.52757 0.45998 7.29234 +458 2 7.24313 12.6736 13.1625 -0.99472 -4.48021 -2.73775 +459 2 6.29798 13.7908 13.6311 -2.25413 -7.45453 -16.6836 +460 1 12.1229 4.49714 13.069 31.9377 20.6864 19.2416 +461 2 12.2438 4.59516 14.0263 7.18846 6.47209 -3.71556 +462 2 11.355 3.98337 13.0276 -40.2556 -25.9573 -14.351 +463 1 11.341 8.18871 7.85243 -8.78275 4.89867 3.16356 +464 2 12.019 7.65272 7.40248 3.56578 3.50389 11.6767 +465 2 11.6495 8.4222 8.75253 4.0122 -9.00416 -11.7002 +466 1 17.1801 10.777 7.4192 7.36201 -8.80257 6.42916 +467 2 17.8272 10.0453 7.20283 -14.4353 25.3005 -3.23105 +468 2 17.1099 11.4706 6.73084 6.53972 -12.3853 -1.04707 +469 1 5.23123 18.1422 11.0533 -19.2518 -11.1169 -0.556795 +470 2 4.68428 18.0818 11.8689 9.03658 -0.237539 -15.4649 +471 2 4.66385 17.8138 10.3113 13.0077 11.3369 14.9543 +472 1 7.56693 17.6215 1.82415 1.62007 -3.46367 5.28784 +473 2 7.78898 16.8334 1.34681 6.63524 -26.0188 -1.32905 +474 2 7.45125 18.2129 1.09256 -3.64481 20.3372 -5.96154 +475 1 1.86389 12.9287 13.6093 11.2123 10.389 11.461 +476 2 1.60858 12.3493 14.3514 0.368407 5.87334 -8.62616 +477 2 2.19533 13.7617 14.0254 -8.04715 -19.4049 -4.74077 +478 1 9.73211 6.79545 14.8053 -13.3635 29.1677 -1.2594 +479 2 9.95388 5.9401 15.1198 6.74212 -35.5267 16.6171 +480 2 9.99758 6.80472 13.8879 2.87601 5.55808 -10.3757 +481 1 15.2079 4.3816 10.7747 2.87683 -10.6846 -6.34453 +482 2 16.1141 4.09829 10.8354 14.0041 -14.4682 -8.99775 +483 2 15.2413 5.10857 11.3759 -13.982 19.572 13.657 +484 1 11.1943 6.12299 0.161942 7.30858 3.38886 3.78771 +485 2 11.3169 5.17116 0.363074 -11.79 12.5462 -9.55941 +486 2 10.2709 6.35961 18.5708 8.1781 -12.6509 6.67443 +487 1 0.185288 11.3311 15.1365 -30.887 25.32 -22.6423 +488 2 18.3259 11.8316 14.411 15.9364 -20.9841 19.9458 +489 2 18.5436 11.8171 15.9275 6.31494 -1.3813 -2.75882 +490 1 7.07253 9.14554 7.26503 -12.8693 -9.44748 7.54332 +491 2 6.53496 8.39024 7.60511 8.01051 18.2562 -7.56901 +492 2 7.96025 8.78683 7.22728 5.66006 -0.214789 -0.295522 +493 1 18.4466 15.4455 12.3524 0.715601 -5.5542 4.25712 +494 2 0.765537 15.5739 12.2932 -9.35503 -1.07101 -3.81958 +495 2 18.1041 15.6865 11.4834 1.82716 1.84183 -0.0676895 +496 1 16.5728 4.36435 5.2485 -25.4993 -8.29978 29.4912 +497 2 16.6816 3.92322 6.14286 5.98391 16.1522 -30.7717 +498 2 17.375 4.39451 4.72672 17.8313 -3.46111 1.89189 +499 1 17.7791 3.0704 10.7152 16.7916 7.15275 7.98838 +500 2 0.0816242 3.14072 10.966 -13.8603 5.05813 -1.71981 +501 2 17.7027 2.20602 10.3066 -7.17166 -8.4112 -5.21368 +502 1 12.3075 0.0618611 10.1685 -8.15907 17.9474 -0.312818 +503 2 11.3684 0.344551 10.3468 27.9971 -1.27027 -0.956139 +504 2 12.8942 0.865557 10.2681 -22.4015 -23.39 -3.54403 +505 1 10.3613 9.82386 12.3172 12.1455 12.129 19.7304 +506 2 11.1427 9.8808 12.9129 -10.2174 -2.53791 -7.09814 +507 2 10.1997 8.88396 12.252 -0.966331 -12.4705 -0.927319 +508 1 0.481536 2.83002 7.02126 3.70324 23.8076 -10.0458 +509 2 0.770856 3.62826 7.51109 -3.83076 -19.2444 -0.666321 +510 2 0.694466 2.06428 7.55035 5.7415 -3.83046 10.8422 +511 1 0.467049 15.2425 6.91705 -4.45928 -38.0226 -11.2702 +512 2 0.600151 15.6263 7.78281 2.30728 -6.41275 13.0317 +513 2 0.61271 14.2361 7.00049 -2.84554 47.7716 -5.16909 +514 1 16.9541 7.01237 15.3291 23.6374 -7.48971 -3.1828 +515 2 17.7457 7.53254 15.1705 -1.99719 18.034 -6.10418 +516 2 17.38 6.19105 15.5941 -13.3003 -10.4743 0.120416 +517 1 9.01017 12.4224 8.1441 -46.2717 9.6088 -11.1501 +518 2 9.26268 11.8248 7.45061 25.2615 -14.9445 -10.6927 +519 2 8.05034 12.5239 7.91838 26.5695 6.53823 20.3475 +520 1 1.26455 1.94093 3.05316 3.58571 9.71968 -12.011 +521 2 1.22461 2.59742 2.34045 -8.12686 -11.986 1.71554 +522 2 1.93366 2.31359 3.63129 0.35358 -2.72116 4.87465 +523 1 4.13309 15.1146 9.63821 -4.623 1.46382 -0.938733 +524 2 4.12694 15.148 8.67475 -7.89004 5.45838 -0.100118 +525 2 4.98588 14.7259 9.81048 11.3537 -4.87926 10.963 +526 1 7.17766 2.17952 14.5652 7.62536 9.73749 11.0593 +527 2 6.96972 1.69872 13.7643 -0.327528 -0.451328 -7.35604 +528 2 7.66158 2.98182 14.3072 -3.86315 -8.18785 -0.50787 +529 1 18.6094 14.7115 2.1553 18.1066 -29.4746 -3.14947 +530 2 0.852094 15.108 2.23259 -6.38197 3.09186 -0.259441 +531 2 17.9366 15.3527 2.32074 -15.2526 23.2774 3.26778 +532 1 9.94663 2.7868 12.9455 2.69617 -13.1789 -11.1834 +533 2 9.77369 2.19316 12.1903 7.43131 1.21406 6.14773 +534 2 9.20096 3.38667 12.9408 -6.30409 9.38042 4.37845 +535 1 2.80852 8.91644 13.0153 -16.8956 -9.28674 -0.0207487 +536 2 3.13809 9.78934 12.8448 9.36486 20.7895 -4.33486 +537 2 3.52774 8.43066 13.407 13.2058 -10.3846 6.75792 +538 1 3.23128 8.35577 3.63883 6.10249 8.71431 60.2633 +539 2 3.54401 9.08838 3.13137 7.96401 15.5303 -21.3649 +540 2 3.46232 8.64756 4.58519 -13.4978 -19.9669 -35.5279 +541 1 5.63324 7.19832 8.5125 -13.133 -10.0414 6.96154 +542 2 5.51092 6.25688 8.34615 12.8941 -5.44374 -4.51219 +543 2 4.92213 7.36133 9.14092 2.83191 13.4678 4.26874 +544 1 14.878 1.27944 2.0109 -7.35803 -30.2596 -13.1701 +545 2 14.8616 1.98275 2.64555 4.54601 24.3613 2.83628 +546 2 15.264 1.50064 1.14913 0.22226 12.7122 6.62367 +547 1 8.2353 15.1956 0.84899 9.2054 13.6294 -15.3468 +548 2 9.04355 15.0937 1.38227 -7.5254 -5.87742 4.76726 +549 2 7.50355 14.6763 1.20804 4.58246 -4.32042 7.88142 +550 1 15.6328 1.34461 7.23795 -19.9173 -11.1245 -9.46976 +551 2 14.9591 0.718796 6.85982 16.5955 19.1651 8.9454 +552 2 15.1508 2.16575 7.45752 1.02199 -7.71962 -3.30529 +553 1 4.91374 13.0908 18.526 15.2565 -4.60213 14.3208 +554 2 5.33439 13.1154 0.77269 -6.07604 1.59812 -16.6926 +555 2 5.51105 13.5936 17.9543 2.83588 -2.74206 0.160853 +556 1 15.3493 8.4742 18.1502 12.1518 9.73195 -18.1744 +557 2 15.7592 9.1135 17.5088 -10.0207 -13.011 16.7995 +558 2 15.2243 8.95162 0.336167 -0.033387 6.18709 -0.40176 +559 1 12.0721 3.03363 18.372 7.89134 -10.3745 2.1206 +560 2 12.0185 2.56449 0.551271 -8.88822 8.03447 17.3967 +561 2 12.5632 2.36483 17.898 4.02516 4.57474 -24.0136 +562 1 13.2076 12.6757 5.17908 4.47921 -5.37266 1.03993 +563 2 13.7293 11.9632 4.79272 -2.12471 -1.88137 -7.76598 +564 2 13.3867 12.5644 6.11349 -3.52883 8.17381 9.78336 +565 1 6.04737 7.04753 0.0353989 10.049 -23.447 -5.31085 +566 2 6.01346 7.99319 18.6275 -7.37118 27.2698 7.20756 +567 2 5.32085 6.74358 0.593628 -6.10646 3.40609 1.47388 +568 1 17.7373 16.0235 15.0083 12.9173 -11.5355 46.7271 +569 2 16.9426 16.5159 15.2406 -3.68569 -0.0523083 -17.9381 +570 2 17.9142 15.8937 14.0864 -12.7219 4.58342 -31.2732 +571 1 13.1912 1.0014 16.5506 10.6966 -14.1722 10.2872 +572 2 14.1553 0.911674 16.6931 -11.9901 3.10273 -3.01829 +573 2 12.8874 0.074803 16.5753 -2.30324 8.04411 -4.14072 +574 1 11.1133 14.5665 7.20897 13.0955 23.3619 -16.6223 +575 2 10.3963 14.2935 7.74934 -21.4591 -15.3449 18.7975 +576 2 11.8402 13.9563 7.34501 4.8973 -5.05394 6.63835 +577 1 17.5096 8.63113 2.08657 0.966478 12.3426 12.6691 +578 2 16.6632 8.50317 2.50987 -10.5053 2.55961 10.3047 +579 2 17.5113 7.91267 1.47949 7.23292 -21.4893 -25.4513 +580 1 12.353 7.99884 2.01581 -2.70101 10.6364 -12.6504 +581 2 12.1945 8.88312 1.63494 1.68617 -6.44935 12.5501 +582 2 11.9639 7.41552 1.35659 -1.58766 -9.18843 -2.08326 +583 1 11.8879 14.6194 10.3406 -20.0746 -33.6598 -22.8547 +584 2 12.0361 13.784 9.8263 4.17148 28.2224 18.5196 +585 2 10.9018 14.6878 10.3309 21.6541 8.7111 3.83339 +586 1 6.88836 7.04362 15.6058 16.1194 20.5136 16.4981 +587 2 7.8035 7.27617 15.3369 -14.4637 -10.2261 -3.41305 +588 2 6.75267 7.59066 16.4113 -4.12685 -13.7627 -18.0291 +589 1 8.00073 4.72844 13.473 32.6072 13.4681 12.0072 +590 2 7.24466 4.78195 12.9199 -26.1194 -0.34176 -19.7698 +591 2 8.43099 5.60279 13.3668 -6.56701 -17.694 4.3215 +592 1 13.409 12.181 14.2619 -2.29334 -12.519 -3.59046 +593 2 13.0674 11.2691 14.1939 2.47622 3.528 5.79283 +594 2 13.8091 12.3245 13.3914 2.14013 7.29019 1.49174 +595 1 14.8335 9.42126 7.30208 -1.23415 -9.7028 -7.755 +596 2 15.6553 9.87909 7.43544 15.0677 5.06613 0.278043 +597 2 14.1895 10.0298 7.62302 -19.0881 6.3544 7.09879 +598 1 12.6523 17.0615 3.07749 -9.63712 20.8437 4.73829 +599 2 12.9489 17.4748 3.92954 -9.59054 -7.90452 -22.4084 +600 2 12.0211 17.6908 2.6147 24.5964 -20.1603 22.3384 +601 1 1.16316 7.14216 17.4575 -7.53687 9.98877 -12.7143 +602 2 0.304551 7.18474 17.9202 3.89796 -5.88799 -6.19513 +603 2 1.03245 7.53978 16.5617 1.30151 -5.77621 16.2427 +604 1 12.7701 5.15004 15.6505 19.6392 -10.8067 9.95473 +605 2 13.4563 4.50157 15.9538 -13.2351 19.2956 -11.0391 +606 2 13.2014 6.03319 15.6187 -0.0564141 -13.897 1.41482 +607 1 2.5292 3.39223 4.98971 -11.294 24.8894 43.5462 +608 2 1.79321 3.13497 5.63732 25.431 9.26734 -19.6171 +609 2 2.95221 4.24201 5.36402 -18.0427 -37.3772 -14.0443 +610 1 8.3195 11.2975 13.4498 34.4282 -42.0873 60.0692 +611 2 8.53145 10.9623 14.3727 -32.5783 27.093 -24.5589 +612 2 9.06913 10.8398 13.0623 -1.46455 6.72769 -32.5395 +613 1 12.8789 1.33599 13.3369 -0.326833 21.0111 -2.4484 +614 2 13.4114 1.42549 12.5087 -12.3149 4.19021 14.3531 +615 2 12.3728 2.16885 13.5095 17.1543 -18.8215 -15.124 +616 1 6.3438 13.6989 2.14861 -9.76603 2.4566 0.239062 +617 2 5.66699 13.9965 2.80165 17.5467 -9.19207 -8.6938 +618 2 6.94024 13.0708 2.57673 -0.273551 -0.649347 7.27334 +619 1 15.9211 6.60722 12.7931 -16.6599 -18.553 -4.38331 +620 2 16.3967 7.19214 12.2261 12.0088 12.5524 -15.4249 +621 2 16.3823 6.6241 13.6257 5.92705 1.19016 14.7721 +622 1 16.8355 0.712467 9.59592 -3.36362 -23.3789 -3.56206 +623 2 16.7779 18.376 9.75078 1.74957 20.9638 -0.413143 +624 2 16.4581 0.840534 8.70411 1.17104 2.38037 5.50581 +625 1 6.14488 11.7511 8.38011 -0.18946 -41.167 -3.37934 +626 2 5.27459 11.5011 8.78729 18.3987 2.85732 -10.3128 +627 2 6.60987 10.8879 8.11154 -22.1828 30.5528 10.1053 +628 1 2.89693 8.62105 0.44295 -56.4203 1.00956 -31.5069 +629 2 2.27197 8.22062 18.4324 34.822 -7.67477 5.45833 +630 2 2.23776 9.23156 0.789096 17.398 15.3469 20.296 +631 1 10.1637 10.4615 6.50349 -4.04384 3.34709 -8.13679 +632 2 10.5967 9.72069 6.94847 1.64295 -0.870339 0.249421 +633 2 10.4974 10.4621 5.5852 -1.057 -0.999308 12.8758 +634 1 6.73224 15.6973 6.55436 -2.09809 -5.48823 4.73835 +635 2 7.11043 16.1412 7.33204 2.41282 1.16671 -8.98558 +636 2 7.01002 16.1566 5.74315 2.18916 7.51026 7.17736 +637 1 6.44608 13.1679 5.58195 -4.20705 -14.9444 9.79279 +638 2 6.65412 13.9682 6.06813 3.08652 7.67851 0.170606 +639 2 6.07667 12.5708 6.24938 0.761343 1.39557 -4.00611 +640 1 16.8208 12.5604 9.84104 -2.42329 -13.6856 -22.0974 +641 2 16.9708 11.9197 9.11347 0.32984 0.887075 14.5477 +642 2 16.637 13.3652 9.35916 0.987515 11.3295 4.43609 +643 1 6.04174 2.95051 2.84722 -0.719082 -29.0389 17.5165 +644 2 6.39757 3.79665 2.63265 6.28437 26.7212 -14.5644 +645 2 5.5959 2.56013 2.08759 -0.264068 2.45464 -11.4985 +646 1 10.912 3.32579 3.30021 -11.54 -3.72468 -0.286686 +647 2 10.265 3.99241 3.57025 6.99069 0.708994 3.18227 +648 2 10.4899 2.90229 2.54711 3.22659 -3.75767 -5.68185 +ITEM: TIMESTEP +20 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.70913 7.06604 17.9499 1.08039 -7.3052 -10.6944 +2 2 7.76309 6.93671 18.0927 2.86377 -0.0634365 6.14939 +3 2 8.89082 6.62218 17.113 -0.435012 1.17195 3.96762 +4 1 18.5701 8.27154 6.84569 7.63886 -4.25596 16.0618 +5 2 0.0770478 8.01704 5.94511 2.80666 -2.10014 -27.175 +6 2 0.448594 7.6266 7.34851 -2.05713 5.96795 6.45131 +7 1 8.39922 18.5714 6.82203 6.72948 10.2859 -1.45868 +8 2 9.32775 0.155905 6.65662 -6.00666 -1.87083 0.283604 +9 2 7.88802 0.6421 6.41318 2.19693 -3.22314 0.641978 +10 1 6.59462 1.83749 11.6886 4.57701 1.91935 4.50468 +11 2 5.92153 2.26167 12.2253 -5.29818 6.79114 -2.36061 +12 2 6.2022 0.990271 11.4833 -4.39091 -13.1588 -5.35683 +13 1 7.12455 5.7334 2.35273 -30.6289 32.8622 11.4294 +14 2 6.61502 6.28908 3.00258 14.1285 -25.9969 -7.59408 +15 2 6.93422 6.24286 1.54682 10.1555 -14.3812 -3.81516 +16 1 16.2065 10.1646 16.1262 8.40668 11.1152 -6.07805 +17 2 17.0895 10.2474 15.7446 -2.7739 -5.15617 3.84543 +18 2 15.9438 11.0841 16.2665 -7.12418 -3.1551 3.11568 +19 1 10.6155 14.9936 2.32061 -1.92123 -0.42827 -4.10202 +20 2 10.587 14.5409 3.17342 -1.90113 -4.17135 2.45193 +21 2 11.1106 15.7965 2.49753 3.42935 4.58062 3.08668 +22 1 17.1538 8.25609 10.4362 5.05968 0.945942 4.2849 +23 2 16.7065 8.97876 10.9029 -1.41924 -5.56537 3.25582 +24 2 18.0123 8.61559 10.168 -2.45464 0.72557 0.389593 +25 1 14.8661 15.8683 16.3562 3.75833 -10.1031 -0.407994 +26 2 13.9609 16.1531 16.2809 -17.2441 8.84265 -1.93831 +27 2 14.8525 15.2671 17.1114 5.79928 3.60638 8.20478 +28 1 12.159 13.3907 0.439783 -6.21112 9.36015 -5.49833 +29 2 12.0312 13.5738 18.1447 5.07318 -6.56614 -2.93527 +30 2 11.6434 14.08 0.875998 -3.18612 -5.19303 11.2101 +31 1 9.2695 5.40921 4.0396 -15.9764 -20.2303 6.13461 +32 2 8.8083 5.02157 4.82949 8.30048 18.0685 -17.5094 +33 2 8.61456 5.30675 3.30783 11.5288 9.4755 11.0493 +34 1 1.82939 4.25621 11.6493 -6.71206 2.38393 -0.709376 +35 2 1.74358 5.20905 11.8686 0.595776 -11.527 -1.23597 +36 2 2.30823 3.82152 12.3665 0.967745 0.8605 0.134832 +37 1 1.98223 6.83069 8.36497 -5.35455 0.0641687 -19.1444 +38 2 2.41924 7.2303 9.11786 5.68758 -2.51321 7.89524 +39 2 2.03012 5.87061 8.47368 0.241822 -0.370612 9.81388 +40 1 5.39801 4.40718 7.93771 10.9733 2.82986 12.12 +41 2 5.47637 3.44759 8.05616 -6.09239 2.90192 -10.948 +42 2 4.7514 4.61131 7.25273 -1.49389 -3.85519 0.176314 +43 1 3.26825 2.92232 17.539 -14.9988 14.8633 6.4114 +44 2 3.91862 3.43305 17.0175 -2.74895 -4.28964 2.11315 +45 2 2.69145 3.57031 18.023 20.6758 -7.505 -11.8237 +46 1 7.47034 5.2735 6.10589 -2.49502 5.37071 -3.04547 +47 2 7.84271 5.98269 6.68437 -5.78386 -20.7203 -0.884416 +48 2 6.94663 4.6123 6.60405 7.6241 17.9385 5.03136 +49 1 9.77266 7.01281 11.9821 10.4665 -1.38292 10.7277 +50 2 10.3585 6.42202 11.517 6.59042 -6.6592 -2.49871 +51 2 9.12807 7.25863 11.3259 -16.7919 6.8996 -8.63143 +52 1 14.096 3.56038 8.06303 -5.03459 -1.11151 -11.1946 +53 2 13.7156 4.24767 7.5046 0.899669 0.845681 1.92473 +54 2 14.4812 4.01512 8.80943 2.7486 3.89851 9.64387 +55 1 4.73966 17.2567 4.00996 -0.195125 14.326 -18.5317 +56 2 5.55163 17.7707 4.1353 -4.1295 -8.09403 5.71009 +57 2 4.38972 17.5915 3.15482 -7.00181 -7.87351 15.3992 +58 1 16.5025 16.6092 10.0733 13.1432 9.20378 8.07617 +59 2 15.9712 16.6856 10.8668 -9.96451 -5.5735 1.54085 +60 2 15.9848 16.1464 9.41138 -7.70063 -5.20479 -0.44901 +61 1 1.97052 4.91045 0.450899 1.06366 9.69844 4.9192 +62 2 2.61093 5.33981 1.06219 -5.49885 -10.5105 -8.09306 +63 2 1.57388 5.6737 18.6422 7.70456 -7.85061 -0.972244 +64 1 11.7662 13.3441 16.2815 -7.88535 5.38496 10.7421 +65 2 11.2704 12.5109 16.442 6.50023 4.10664 -10.6094 +66 2 12.3479 13.2575 15.5066 -9.92493 -12.14 1.82083 +67 1 10.1201 11.0576 16.9389 3.39974 -19.6625 0.923124 +68 2 10.5319 10.1651 17.0061 -5.17122 15.3709 -2.15755 +69 2 9.17725 10.8754 16.8052 5.13113 2.71984 -2.06215 +70 1 11.7111 17.5152 13.4588 11.325 -2.75861 -1.19784 +71 2 12.3718 17.1152 12.8813 -0.632983 -4.36671 1.26506 +72 2 11.9961 18.4406 13.4806 -4.40298 2.90056 2.38202 +73 1 6.35795 9.30394 12.2283 8.95317 6.42027 -9.35456 +74 2 6.91663 9.09838 11.465 -5.59359 -11.5346 -0.139091 +75 2 6.8458 10.0391 12.6013 -0.320164 5.49925 11.3434 +76 1 16.2195 12.7457 2.69542 0.295574 -29.3957 1.13627 +77 2 17.0216 13.1501 2.38091 9.97003 13.3951 -1.47132 +78 2 15.5842 13.4209 2.91145 -9.8096 20.1499 -2.69183 +79 1 0.634077 12.5728 5.88372 -7.9484 2.86768 -4.89493 +80 2 0.988616 12.3569 5.00851 -6.1101 5.76055 1.83916 +81 2 18.334 12.7959 5.71409 15.811 -6.64636 4.43625 +82 1 5.2077 16.407 18.4749 -9.68849 -0.552221 -6.28119 +83 2 5.84718 15.7794 18.0984 2.41425 5.32286 5.94338 +84 2 5.56586 16.8292 0.618687 8.26881 -4.78153 -1.34873 +85 1 0.531249 7.63213 4.08542 33.6963 23.9515 -16.2824 +86 2 18.6021 7.94352 3.35108 5.75308 0.311196 11.7347 +87 2 1.44781 8.03396 3.8909 -38.1012 -20.2476 4.98268 +88 1 3.13519 8.90219 6.5128 -18.1806 -1.10975 19.7922 +89 2 3.61721 8.66647 7.3217 -0.167991 0.711605 -10.7948 +90 2 2.18954 8.88363 6.78472 17.5501 0.713198 -9.35234 +91 1 7.30642 10.3086 16.1993 0.33826 1.86993 11.5423 +92 2 6.5825 10.5097 15.5962 -1.40069 -1.74837 7.12047 +93 2 6.94436 10.2588 17.1142 -3.68695 0.804433 -15.344 +94 1 11.1033 1.05136 4.99998 6.51415 -6.68887 15.4104 +95 2 11.3804 1.86173 4.55399 -8.93638 -1.72916 -9.27788 +96 2 10.7652 0.40817 4.35737 0.804793 8.53975 -5.36269 +97 1 4.41906 2.71829 13.1993 1.75265 -17.8891 31.6776 +98 2 4.61925 3.15892 14.0364 2.0928 12.2335 -7.50334 +99 2 4.34595 1.79439 13.5397 -3.31279 7.49147 -22.0731 +100 1 8.39429 10.0534 1.8011 7.989 6.96853 5.58503 +101 2 8.43083 10.7556 2.48299 -4.47719 -6.35615 -3.34103 +102 2 8.76263 9.25633 2.22388 -6.49712 6.95404 -2.63041 +103 1 10.5097 1.74962 15.5619 -18.3761 -0.922722 7.55335 +104 2 11.4225 1.47346 15.6803 4.80494 4.8298 -6.32182 +105 2 10.3374 2.00269 14.6445 6.81104 -1.01801 -3.49857 +106 1 2.7507 12.9226 7.76103 -0.99391 -3.54814 -5.35437 +107 2 3.2837 13.6196 7.35675 1.026 0.47841 4.16479 +108 2 2.1823 12.6261 7.03948 -5.64928 1.37633 4.69044 +109 1 3.65655 11.6901 5.29539 -1.74666 1.04695 -5.47464 +110 2 3.42979 10.9863 5.91968 -0.390133 2.11749 -7.53732 +111 2 2.90341 11.8434 4.69867 6.59799 -3.91283 3.78854 +112 1 6.86195 14.4839 16.8677 -6.59977 -5.37582 9.26387 +113 2 7.63594 13.9204 16.7929 -0.0312736 1.63672 -3.94334 +114 2 6.43125 14.5303 16.0039 6.73415 3.59122 -3.18668 +115 1 14.1795 14.5536 3.39757 15.4782 -5.44823 -10.5 +116 2 13.7027 15.3725 3.25557 -8.02005 3.41109 -0.200737 +117 2 13.6761 13.9828 3.97966 -5.46722 0.130817 9.75683 +118 1 8.30625 18.1704 16.0558 -18.3501 -5.93921 0.16691 +119 2 8.73243 17.3486 16.3757 13.662 16.7968 -4.53324 +120 2 8.86048 0.311637 15.8745 11.2379 -14.2941 4.19403 +121 1 4.7262 1.6175 4.92485 1.6266 19.4211 -17.3379 +122 2 3.85517 2.05812 4.84475 13.0303 -7.24689 7.72044 +123 2 5.31448 2.15314 4.34837 -14.7695 -11.1634 6.67198 +124 1 15.0789 12.7964 16.4332 -6.30353 8.33681 17.3183 +125 2 14.5699 13.1854 17.1557 10.6035 -4.81202 8.18161 +126 2 14.431 12.7912 15.7403 -5.45963 -10.7064 -24.7799 +127 1 15.7876 18.4014 16.8102 7.97993 -1.6905 34.0366 +128 2 16.3475 18.509 17.631 -13.1355 2.97046 -27.3317 +129 2 15.4303 17.5059 16.9211 5.07282 4.66478 -9.26997 +130 1 1.15379 1.15776 16.5585 8.66192 -1.89028 -5.04545 +131 2 1.90132 1.75074 16.7615 -7.4852 -3.92147 5.78546 +132 2 0.484053 1.2881 17.242 6.61018 5.41271 -0.381602 +133 1 18.0958 4.56873 15.8951 8.25715 -8.22974 -2.59939 +134 2 18.5403 4.03662 15.2192 -4.31028 2.25805 3.56674 +135 2 18.6753 4.5681 16.6654 -3.11748 0.528024 -3.18079 +136 1 12.2229 16.9717 16.1366 4.99185 -14.9968 15.1993 +137 2 11.5697 16.3784 16.5746 6.13992 18.0067 -10.7689 +138 2 12.0903 16.9196 15.1862 -11.661 1.79059 -6.40221 +139 1 15.9175 2.52925 17.9868 -5.04918 24.4496 -1.91719 +140 2 15.7053 3.35036 18.4645 1.43445 -9.55155 0.206063 +141 2 15.6037 2.74854 17.0829 8.19816 -13.208 8.21894 +142 1 6.7035 13.812 10.2396 3.19471 14.7437 0.534165 +143 2 6.61208 13.6203 11.1841 -1.85117 -10.3739 -2.65392 +144 2 6.65674 12.9942 9.7292 -2.15383 -4.24588 3.01674 +145 1 10.13 18.2471 2.79005 6.2323 7.4499 -7.90816 +146 2 10.2641 0.289717 2.1086 -4.88175 -4.44055 6.63338 +147 2 9.27512 17.8471 2.59242 -0.00557908 4.28296 0.85488 +148 1 2.97726 17.7544 6.09154 9.3411 -8.798 -12.7807 +149 2 2.21419 17.6669 5.51339 -17.57 2.09099 8.77855 +150 2 3.67394 17.6484 5.43984 9.00485 8.25893 -0.00709571 +151 1 12.565 16.9537 7.99058 7.14198 1.79921 -4.31208 +152 2 11.8238 16.3251 7.88339 1.67036 10.005 4.65414 +153 2 12.3624 17.6704 8.62526 -6.57036 -14.6618 3.16709 +154 1 14.8823 15.2807 8.26789 -1.91265 -14.526 28.7428 +155 2 14.153 15.9118 8.23916 -2.47753 6.09246 -10.9919 +156 2 15.4304 15.3156 7.48892 0.613021 10.1448 -23.5664 +157 1 17.5919 18.2849 0.376053 -34.2379 -2.64943 -3.08159 +158 2 18.3697 17.8673 0.0312256 25.6277 -7.0964 -1.13253 +159 2 17.798 0.454484 0.829223 12.3697 7.05842 3.85092 +160 1 0.890355 10.3869 1.40531 11.5261 -26.8893 18.421 +161 2 0.106732 9.81739 1.52594 3.68606 12.403 0.666184 +162 2 0.670163 11.0869 0.811123 -14.943 21.2909 -16.3167 +163 1 1.59243 12.2061 3.32787 10.8868 -1.98125 32.4665 +164 2 1.41581 11.4302 2.79423 -4.35317 -0.696655 -17.6875 +165 2 1.68603 12.9921 2.7891 -2.29445 2.46974 -13.9165 +166 1 0.556424 17.2525 4.88159 28.516 -3.31441 -27.2608 +167 2 -0.112492 17.9263 4.93691 -11.7284 7.93843 13.1539 +168 2 0.513874 16.5834 5.55808 -11.2757 -6.6263 16.6148 +169 1 1.11617 0.979823 9.41029 -8.01472 5.90786 -6.49609 +170 2 1.17088 0.754182 10.3385 12.3333 -8.44182 10.8127 +171 2 0.193916 0.78552 9.22994 -1.98368 -3.92324 -6.63209 +172 1 16.7786 2.33534 13.2836 0.301257 -1.02782 -8.61363 +173 2 16.9098 2.55877 12.34 -0.551981 -1.96326 12.3514 +174 2 16.5533 1.39033 13.3371 -1.81134 4.54396 -2.66642 +175 1 2.50838 15.8231 12.1881 11.0759 -0.61625 -4.91684 +176 2 3.05623 15.4799 12.9137 -5.11001 1.87196 -7.11666 +177 2 2.97562 15.6336 11.349 -1.75425 -0.738878 7.05871 +178 1 16.4241 15.5762 5.95419 20.8818 34.7414 3.73321 +179 2 17.3417 15.6388 6.29893 -10.1511 -9.39035 -1.02331 +180 2 16.3256 16.4387 5.46724 -6.92566 -23.7939 4.29358 +181 1 5.82318 5.04015 11.787 7.38202 -1.28642 -1.97288 +182 2 5.53279 5.76584 12.3478 -8.19426 6.74642 1.34004 +183 2 5.25308 4.28957 11.9879 -3.19521 -0.0404241 -0.10221 +184 1 15.2058 4.86095 0.714988 -15.0911 -0.578133 32.6943 +185 2 15.0554 4.65905 1.68214 1.80466 1.09263 -27.7183 +186 2 14.3514 5.22673 19.0716 10.184 -3.76227 -2.57358 +187 1 16.3414 16.3313 2.1188 1.69452 -20.4231 -15.1031 +188 2 15.9696 16.7397 2.89766 0.772445 11.9995 9.83785 +189 2 16.487 17.0139 1.46036 1.64169 8.90638 2.00624 +190 1 0.27953 4.87193 3.80304 22.0083 21.7264 1.42732 +191 2 0.488965 5.84197 3.75834 -13.581 -23.7134 5.51739 +192 2 1.12962 4.47493 4.05501 -10.8528 -1.93786 -0.672788 +193 1 2.93644 15.0118 15.0505 -0.31189 -6.67479 38.4938 +194 2 2.77152 14.5973 15.941 9.17422 6.49202 -18.5047 +195 2 2.6087 15.9081 15.2082 -8.55577 3.59906 -10.383 +196 1 1.11893 14.5977 9.54871 15.5404 -15.1461 3.70851 +197 2 2.05973 14.499 9.39244 4.56619 15.8955 -5.72674 +198 2 0.980037 13.7309 9.94382 -18.1835 3.0763 3.0761 +199 1 13.6623 16.6444 11.5318 -24.61 2.13122 1.95847 +200 2 13.1623 17.4223 11.2076 12.7863 -8.68657 -5.97173 +201 2 13.1098 15.8918 11.2458 9.29846 2.29742 -4.43006 +202 1 4.71401 1.48013 0.724257 -0.188744 -1.90188 8.47653 +203 2 4.10877 2.04213 0.209428 1.54459 -7.39683 1.44825 +204 2 4.1847 0.878426 1.28084 -4.13807 4.124 -10.8706 +205 1 1.4317 18.499 11.8861 -0.747589 2.74228 -9.05649 +206 2 1.26248 0.376362 12.6752 -1.22453 3.10674 7.57799 +207 2 1.76508 17.6414 12.1696 1.67944 -1.01146 1.59049 +208 1 11.5426 10.114 4.08871 14.5973 5.39555 -25.8673 +209 2 11.3947 10.5181 3.18641 4.0612 -8.18021 22.6028 +210 2 12.5241 10.0302 4.19261 -20.6338 4.9276 -1.52234 +211 1 8.35442 12.1679 3.75067 -15.8416 -4.27069 -7.38356 +212 2 9.18656 12.6319 3.95442 -10.6107 -0.215004 12.2135 +213 2 7.67679 12.3128 4.45645 22.0699 3.83678 -6.48541 +214 1 14.3334 4.02625 3.28975 21.4077 6.9275 8.44763 +215 2 15.0849 4.22802 3.89908 -16.2072 -5.96795 -3.3621 +216 2 13.5509 4.49592 3.62574 4.82101 -0.669553 -3.42678 +217 1 5.57933 1.73516 7.50739 -24.0378 -31.7376 11.0088 +218 2 4.91074 1.07012 7.91595 32.7583 31.1537 -18.2093 +219 2 5.45045 1.65908 6.53973 -4.97377 0.997246 11.1506 +220 1 17.8945 1.1186 4.8831 -1.36037 -2.43827 -6.93143 +221 2 18.5804 1.42855 4.26031 -6.60553 2.78724 7.64102 +222 2 17.8025 1.76232 5.59874 4.87877 0.216211 -3.29328 +223 1 6.83024 9.40422 4.48506 -14.9488 0.581331 -12.2421 +224 2 6.75886 9.5424 5.43046 9.61942 2.86103 10.3107 +225 2 7.75214 9.21615 4.27366 4.86133 -4.03573 4.34319 +226 1 2.68867 14.9529 1.96243 -3.68441 -0.0776758 1.15821 +227 2 3.24659 14.6776 2.70632 3.58292 1.9147 -7.42106 +228 2 3.21497 14.9558 1.15083 1.81588 -2.88288 8.16929 +229 1 17.2949 12.8929 13.1574 -7.5849 14.4302 -4.04848 +230 2 16.4401 13.3055 13.2858 -13.783 -13.5119 9.83474 +231 2 17.7157 13.6748 12.8001 24.9453 0.592093 -1.55303 +232 1 15.0095 10.5719 1.38917 -11.2702 -15.2105 -5.46509 +233 2 15.5687 11.2426 1.76309 11.9887 12.322 8.95719 +234 2 14.2298 11.0424 1.10476 -6.47688 3.25886 -0.810136 +235 1 5.70264 6.91192 4.53101 4.96234 -7.94583 8.40724 +236 2 5.98573 7.83684 4.52277 1.36545 -0.678753 -1.4492 +237 2 6.33051 6.43499 5.10591 -2.47306 1.6182 -5.79546 +238 1 8.0801 8.26782 10.1943 -2.48094 -3.5573 30.8197 +239 2 8.76371 8.85191 9.85613 0.308879 9.43682 -13.0265 +240 2 7.56027 7.88877 9.48994 -2.62488 -0.283604 -15.3664 +241 1 13.5 18.3149 5.7974 -5.02979 10.2931 3.81039 +242 2 12.85 0.37996 5.63415 -2.0272 -10.2183 1.79381 +243 2 13.182 17.8392 6.59435 1.6098 2.02728 -12.9685 +244 1 0.276709 2.57627 0.11216 -0.0492842 3.76989 10.2262 +245 2 17.9528 2.7291 18.6895 13.0336 8.33648 -1.41355 +246 2 0.811706 3.36861 0.368499 -21.4808 -7.42382 -6.02819 +247 1 12.6714 10.9997 9.76016 -23.5437 -7.71308 -4.31472 +248 2 11.7133 10.8659 9.59681 15.3229 11.3368 0.532821 +249 2 12.914 10.0869 9.9422 13.3726 -3.72203 6.47581 +250 1 0.779958 12.2601 11.0819 -4.3547 -6.1438 5.62044 +251 2 18.4678 12.2984 11.1653 -6.51403 -1.20026 -7.70008 +252 2 1.07438 12.4529 11.9792 8.34734 4.57522 -3.24255 +253 1 5.0586 7.24501 13.467 -14.0099 -7.28532 -8.10759 +254 2 5.49528 8.03405 13.1289 12.6282 1.90126 -2.15469 +255 2 5.51501 6.98287 14.2704 7.34444 5.85192 6.7727 +256 1 1.26105 6.94281 11.8301 -2.26861 -4.26975 2.97 +257 2 0.502637 7.2894 11.3564 -2.98104 -0.152382 -1.57853 +258 2 1.67901 7.71469 12.2201 5.00338 4.10874 -3.32488 +259 1 15.4732 9.48624 12.3091 -7.90575 31.4836 20.4854 +260 2 15.2888 10.4503 12.3878 3.68649 -17.5592 -11.9783 +261 2 15.3484 9.17907 13.2194 3.56004 -6.14635 -9.9625 +262 1 16.6235 12.9071 5.45115 4.22183 -17.5767 13.0612 +263 2 16.4576 13.8585 5.58703 -5.89626 -6.38642 -16.4082 +264 2 16.4453 12.6107 4.54016 -1.61972 14.741 3.30454 +265 1 6.17978 10.0207 0.140312 6.69901 -0.902574 1.02107 +266 2 5.53175 10.4562 0.704359 -7.04498 -0.0752206 -3.29626 +267 2 6.99223 10.1412 0.643131 5.59964 -6.49227 2.85612 +268 1 12.3558 6.06094 4.04059 -1.82306 -10.4932 18.2897 +269 2 12.2948 6.89378 3.5711 -3.30175 6.87328 -14.7087 +270 2 11.4523 5.72881 4.15047 2.03572 4.51633 -5.92335 +271 1 0.151611 12.8143 0.201399 6.45324 -5.46068 -3.81056 +272 2 -0.0140355 13.4798 0.883392 3.4035 3.37155 -1.9342 +273 2 18.3672 13.1447 18.0414 -1.87626 -1.08321 2.97259 +274 1 3.81145 18.5877 8.5912 1.31461 -3.73146 5.16785 +275 2 3.56882 18.0432 7.82418 -6.49798 6.54364 1.53441 +276 2 2.99788 0.372962 8.89657 -5.11276 -3.31294 -4.1744 +277 1 7.4281 17.2705 4.47377 6.46179 23.4452 -11.2721 +278 2 7.96797 18.0618 4.61565 -3.66399 -5.46425 9.5792 +279 2 7.28703 17.3462 3.52078 -0.310988 -11.8901 2.26571 +280 1 9.22893 17.063 12.2466 22.6161 -18.3078 -0.374418 +281 2 9.25634 16.2959 11.6379 -2.98004 10.6911 5.23864 +282 2 10.0783 16.9759 12.7442 -18.2994 12.1316 -6.13803 +283 1 13.3197 12.9538 7.95187 -9.96581 2.72298 -9.05352 +284 2 13.2593 12.2563 8.62517 4.24613 3.77329 1.00191 +285 2 13.899 13.6706 8.22561 11.1032 -0.425478 9.75376 +286 1 14.9719 2.96045 15.3396 1.81329 0.120121 -0.870248 +287 2 14.3995 2.21229 15.1018 3.59949 7.50345 -3.65154 +288 2 15.6901 3.005 14.6772 -10.8991 -3.85704 4.22675 +289 1 9.85324 15.5257 17.0014 3.97317 -4.57748 -3.47476 +290 2 10.3864 14.7538 16.7592 -3.54516 -0.814303 -2.23392 +291 2 9.2485 15.2429 17.6987 -0.194096 3.36496 6.55889 +292 1 11.2976 8.26736 16.5426 7.06128 19.5884 6.19806 +293 2 10.6048 7.82655 16.0501 -2.15009 -7.46249 -5.1526 +294 2 11.6506 7.64084 17.1804 -3.23764 -5.26669 1.48715 +295 1 3.80261 18.1891 16.7286 5.96532 3.63646 9.58286 +296 2 4.2558 17.5705 17.3068 2.57751 -13.4277 -2.28373 +297 2 3.88923 0.356458 17.2317 -6.08372 7.81341 -6.39572 +298 1 2.19516 4.11859 8.94937 -6.46461 1.56382 -5.27436 +299 2 3.07192 3.77694 8.7043 -7.24867 0.753394 12.5906 +300 2 2.01364 3.98399 9.90559 16.1239 2.6739 -11.0998 +301 1 9.88488 10.3605 9.72172 5.12637 14.4569 -2.91242 +302 2 9.60959 11.2332 9.33432 -0.0101703 -19.6763 14.6837 +303 2 10.1282 10.4603 10.6632 -8.0115 2.48909 -7.97128 +304 1 9.71465 0.804575 10.8512 21.7431 15.3431 10.1505 +305 2 9.2832 18.6897 11.2643 -8.53487 -4.69507 -4.97966 +306 2 9.18676 1.22081 10.1628 -13.1132 -5.80645 -3.94121 +307 1 9.20675 15.1716 10.2106 -23.935 -1.88548 4.57185 +308 2 8.85892 15.9372 9.71979 2.38257 -5.68301 1.50138 +309 2 8.39577 14.638 10.4071 17.7258 6.53325 -11.5344 +310 1 1.0072 9.34307 10.3251 -13.5607 -2.30165 -2.87521 +311 2 1.0259 10.3094 10.4263 12.3488 -1.76633 0.307332 +312 2 1.88127 8.96784 10.1532 -1.03643 13.7416 3.72628 +313 1 16.8438 4.87108 8.18901 -4.78961 0.896955 11.5039 +314 2 16.1406 5.46499 8.54396 15.0863 -10.4307 -3.41532 +315 2 17.2081 4.33923 8.92353 -6.78534 8.8584 -10.8667 +316 1 14.6587 14.7041 0.366828 1.30507 -0.478814 3.63059 +317 2 15.185 15.0332 1.12636 -7.04307 -0.464202 -11.0373 +318 2 13.8385 14.3426 0.742198 8.82268 0.591631 -2.33039 +319 1 3.54036 11.0513 9.61487 2.50715 2.61524 -7.45538 +320 2 3.63629 11.5626 10.435 -2.71976 -6.10697 -0.243655 +321 2 3.06413 11.634 8.99273 6.16009 -0.263385 5.30284 +322 1 11.0628 10.8412 1.29387 1.94664 2.31063 1.36488 +323 2 11.3352 11.6508 0.816723 -4.4237 -7.82009 8.11802 +324 2 10.1138 10.7005 1.1254 8.25661 2.0034 -0.662671 +325 1 13.2071 7.092 12.8743 -8.181 6.96481 -7.78695 +326 2 14.1492 6.89693 12.9368 4.59729 -0.0390769 -2.26511 +327 2 12.7747 6.23567 12.7699 0.0352738 -4.27477 4.68983 +328 1 9.62872 1.89049 0.957357 1.17656 -1.16236 13.2501 +329 2 8.73134 1.77169 0.632677 -1.73422 -2.0126 -6.33446 +330 2 10.2301 1.88378 0.211292 -0.739962 2.15457 -7.7161 +331 1 10.5914 13.525 4.7165 6.94092 6.03141 -14.7136 +332 2 11.5001 13.1966 4.5902 -6.55933 -2.4681 12.9436 +333 2 10.616 14.067 5.5206 3.43098 -5.16043 -1.25188 +334 1 14.3018 1.72484 10.9172 13.4371 11.1223 -9.93713 +335 2 15.1272 1.43467 10.5035 -1.81024 -10.6133 4.43081 +336 2 14.4134 2.68551 10.8564 -6.433 0.422524 6.62217 +337 1 14.6521 12.3877 11.7022 -8.45049 -6.71538 5.80805 +338 2 15.5103 12.5052 11.2413 -17.7577 -5.57988 -7.54306 +339 2 13.9188 12.0751 11.1197 22.5147 4.82958 0.534535 +340 1 8.2427 5.06906 9.80652 6.55588 21.6544 3.19941 +341 2 7.41824 5.23391 10.2944 2.41744 -11.9303 -3.89737 +342 2 8.21758 4.20856 9.37923 -10.585 -10.7296 4.55255 +343 1 1.58459 16.8369 18.3321 1.96955 3.78018 0.59611 +344 2 1.85004 17.2184 17.4898 0.0469727 3.49377 1.52109 +345 2 1.98826 15.9645 18.3052 -5.87072 -8.1408 0.0386171 +346 1 1.45085 17.2397 15.3384 19.3024 -11.6024 -7.75777 +347 2 1.52928 18.1033 15.7334 -7.82156 13.9033 4.46915 +348 2 0.523156 17.01 15.2404 -5.15812 1.64021 5.22009 +349 1 3.71432 5.60797 6.16821 -6.42766 23.1509 5.2389 +350 2 3.10788 6.20238 6.65309 4.74203 -10.8724 -0.844938 +351 2 4.31902 6.23597 5.73943 -0.58891 -7.80382 -7.69424 +352 1 12.3617 9.44178 14.1897 14.768 -21.5294 -7.13739 +353 2 12.6854 8.60646 13.7318 -7.61852 23.4532 21.1317 +354 2 12.1886 9.19254 15.1239 0.0190459 -2.13671 -14.4759 +355 1 4.02789 15.2847 6.90037 19.6963 3.91174 -8.53909 +356 2 3.59813 16.0446 6.4807 -5.57314 -2.58109 7.58101 +357 2 4.98627 15.4174 6.72455 -14.0806 -2.64155 5.91133 +358 1 0.604694 8.56382 14.8836 6.38519 14.8729 2.46932 +359 2 0.593576 9.52815 15.0331 -4.38489 -7.16014 1.99766 +360 2 1.21683 8.48632 14.1406 0.0450847 -3.26888 3.80333 +361 1 12.9907 8.33553 10.3435 -10.7244 11.0212 -25.595 +362 2 13.7217 7.85043 9.92864 1.48882 -4.14748 10.5805 +363 2 12.916 8.06476 11.2563 9.06532 -10.0671 12.5191 +364 1 15.3021 7.67479 3.50456 -15.706 -31.6797 19.6454 +365 2 14.5991 7.08356 3.22123 -2.84665 13.9574 -20.9494 +366 2 15.4859 7.21773 4.34079 18.8178 22.1978 3.49889 +367 1 17.3057 6.66581 0.0439089 -0.566439 -0.157214 -4.14934 +368 2 16.9415 5.80914 0.322205 -4.36129 9.908 -1.962 +369 2 16.5386 7.21525 18.4101 8.51434 -8.37768 3.91558 +370 1 8.82219 6.93132 7.84612 -10.1525 -9.67927 6.48857 +371 2 9.74438 7.17539 7.82243 13.4851 9.91198 -3.74634 +372 2 8.75511 6.31699 8.60098 -3.86074 2.18846 -4.69843 +373 1 12.3417 0.621389 1.18077 -6.9564 -3.41972 6.83906 +374 2 13.1525 0.726993 1.70017 3.48999 0.0677543 -9.59522 +375 2 12.4857 18.5505 0.551479 3.63823 3.88808 0.842467 +376 1 5.6677 15.1168 14.5202 -2.89809 14.409 3.62726 +377 2 4.73779 15.2069 14.7798 -2.10515 -4.92641 -4.42493 +378 2 5.95698 16.02 14.2745 1.37709 -12.0745 -2.57764 +379 1 3.85174 6.50812 1.71549 -1.87326 -9.92841 -7.94113 +380 2 3.40118 7.27684 1.32447 4.40945 3.56133 7.79633 +381 2 3.98293 6.6854 2.65555 -2.72837 5.07562 -0.486349 +382 1 3.88774 11.6179 12.2731 7.36248 2.53406 3.74193 +383 2 4.74563 11.9961 12.5096 3.21135 -1.44769 -3.24982 +384 2 3.26188 12.2215 12.6852 -7.1456 -2.35069 3.20446 +385 1 5.4326 3.86602 15.8669 5.46195 27.5847 5.5501 +386 2 6.12196 3.19729 15.7751 -0.292732 -1.96119 -5.07149 +387 2 5.89955 4.7414 15.9262 -11.6823 -23.746 -2.53289 +388 1 14.4519 10.31 4.40466 -0.198609 -22.4452 -14.1251 +389 2 14.647 9.76314 5.18938 0.972168 3.21729 -6.37484 +390 2 14.6939 9.77999 3.59617 -3.45576 13.8176 24.0335 +391 1 7.91012 17.3396 9.21881 -3.47249 -5.09989 3.31179 +392 2 7.12992 17.5549 9.76562 5.48476 5.05439 -11.164 +393 2 8.00718 17.9294 8.44912 -7.46491 1.16212 7.11091 +394 1 4.51961 14.4455 3.97665 1.46094 13.6517 19.4367 +395 2 4.57851 15.3966 4.28178 1.46521 -27.5553 -6.05216 +396 2 4.65578 13.8277 4.74009 -3.41874 17.0045 -15.0106 +397 1 14.2914 7.39173 15.7568 2.67151 4.01398 13.8033 +398 2 15.2382 7.26829 15.5879 -5.04223 1.8615 0.0507223 +399 2 14.2621 7.71182 16.6758 1.37252 -0.910778 -10.0112 +400 1 2.89282 18.2219 1.89623 16.0954 20.7868 19.4211 +401 2 2.43498 17.5738 1.38145 -10.8581 -14.0242 -17.961 +402 2 2.20473 18.7378 2.33948 1.00824 -0.59586 0.163903 +403 1 7.97772 1.60288 4.53639 1.7563 -9.68985 13.008 +404 2 7.31922 2.029 3.97737 7.04095 6.46018 -8.6135 +405 2 8.84264 2.02013 4.43356 -4.53303 1.60821 -5.92451 +406 1 2.59943 14.1332 17.7414 -8.95394 -18.2677 -2.38171 +407 2 1.94944 13.4122 17.9464 12.5244 20.6844 1.19004 +408 2 3.47205 13.7759 17.9983 -8.8914 0.728457 0.900702 +409 1 0.745112 1.69912 13.8711 11.2473 3.52367 -11.146 +410 2 0.914419 1.4049 14.7673 -7.77297 1.70239 6.88788 +411 2 18.4589 1.93825 13.7842 -0.334419 -0.897106 4.15254 +412 1 4.53599 18.6175 13.9535 -3.4557 6.59794 -4.70782 +413 2 5.46815 18.3485 13.9788 -8.18255 -2.00556 -1.03369 +414 2 4.11637 18.3402 14.7801 5.6735 0.958275 2.99437 +415 1 7.096 0.531319 18.3551 -0.694611 7.4496 8.80978 +416 2 7.23097 0.178113 17.4735 2.95576 -3.96306 -6.42653 +417 2 6.14085 0.633472 18.4745 3.33236 6.58102 0.363951 +418 1 16.0915 18.4336 14.0959 0.427379 -0.396215 -8.58483 +419 2 15.3508 17.8946 13.7703 3.59427 8.97013 10.1541 +420 2 15.9721 18.7209 15.0186 -4.35198 -12.8399 -3.85995 +421 1 10.0849 4.5187 16.2702 4.73223 -5.50586 5.92697 +422 2 10.9866 4.63155 16.5807 5.77761 8.19399 -3.69287 +423 2 10.0461 3.5611 16.1717 -6.80252 -1.66686 -4.51665 +424 1 15.8725 17.8845 4.41654 -12.5209 12.7326 5.37596 +425 2 16.3916 18.7124 4.49019 -1.68969 -11.5252 -1.94643 +426 2 14.9593 18.1341 4.67479 17.449 -5.50076 1.40971 +427 1 6.95668 17.3709 13.7302 27.0332 5.97859 23.7699 +428 2 7.35597 17.5596 14.624 -6.60353 0.436933 -26.7426 +429 2 7.73328 17.3113 13.1176 -17.9234 -0.691624 11.5164 +430 1 13.2886 6.54141 6.708 -19.4099 -8.32294 21.4331 +431 2 14.1944 6.83212 6.62317 10.4169 5.52785 -11.9279 +432 2 12.8902 6.38702 5.85009 7.8467 0.777822 -14.5162 +433 1 7.70655 2.38278 9.20977 12.6343 0.60353 -10.8933 +434 2 7.2325 2.23152 10.0347 -6.87682 0.627979 2.4454 +435 2 7.14224 2.1131 8.46352 -1.96859 -1.38987 10.9664 +436 1 15.1599 14.8609 13.6555 2.14917 -2.72077 3.1958 +437 2 15.0894 15.1454 14.5818 -4.10533 -0.470809 -6.08849 +438 2 14.3857 15.1548 13.1581 4.50097 1.9243 4.2209 +439 1 9.31836 8.32368 3.71602 18.5592 -2.51714 11.5674 +440 2 10.1335 8.79007 3.99631 -8.14035 -3.14117 -4.90658 +441 2 9.4898 7.3827 3.90713 -7.2783 5.8685 -3.93333 +442 1 17.7186 13.4905 16.4359 -1.51289 22.2408 -13.156 +443 2 16.7625 13.3639 16.3649 1.62841 -7.26982 3.16217 +444 2 17.8329 14.3608 15.9953 4.68582 -10.1291 6.26608 +445 1 5.02763 10.6563 2.64305 -2.13744 -9.22816 3.31541 +446 2 5.67739 10.1782 3.18798 -3.0773 8.85482 -0.1212 +447 2 4.59818 11.3042 3.21285 3.70326 -1.5106 2.19329 +448 1 3.72149 8.34459 10.2919 -0.179455 -7.68631 -12.7595 +449 2 3.82782 9.26393 10.0171 0.460185 9.10653 3.72446 +450 2 3.7984 8.31763 11.2506 0.24707 1.5831 -0.943414 +451 1 16.0782 7.09232 6.27704 3.78536 -20.3998 -1.61032 +452 2 16.8668 7.5306 6.63092 -6.12864 4.03671 -1.53431 +453 2 16.2929 6.14181 6.32149 -2.48234 12.3559 -4.92911 +454 1 15.1572 7.02511 9.10581 3.8117 16.1939 -22.7388 +455 2 15.9823 7.33517 9.52567 -10.9007 1.4123 -2.48218 +456 2 15.0452 7.59247 8.29613 6.45133 -12.7204 22.5185 +457 1 6.42341 13.1088 12.8743 -8.95622 -6.97199 -8.56847 +458 2 7.13157 12.5608 13.2501 0.579484 9.04377 -2.95583 +459 2 6.27581 13.8943 13.4207 1.62934 -6.42573 5.92996 +460 1 12.1251 4.48872 13.0852 20.6978 11.8008 -11.4801 +461 2 12.1861 4.63134 14.0408 -7.38726 -2.06828 2.45652 +462 2 11.3124 4.06154 12.8314 -12.072 -7.43803 9.29181 +463 1 11.3394 8.19587 7.85205 11.1059 -10.4301 17.8484 +464 2 12.0348 7.61277 7.52234 0.357557 0.521252 -13.0071 +465 2 11.6101 8.269 8.78041 -6.91702 7.4869 -1.95681 +466 1 17.1867 10.7889 7.4395 14.5297 -2.81026 -23.5185 +467 2 17.9096 10.1869 7.16109 -12.9834 1.71839 15.1597 +468 2 17.0415 11.3048 6.62611 -4.1729 8.16775 12.482 +469 1 5.24074 18.1281 11.0581 -15.2173 -3.98599 -8.34189 +470 2 4.58924 18.0057 11.7782 10.2636 1.95052 -8.13419 +471 2 4.73144 18.0737 10.2167 7.33147 4.07832 13.9505 +472 1 7.57528 17.5815 1.8237 -4.07192 12.6902 15.9513 +473 2 7.93668 16.805 1.40258 -2.93669 -7.99436 -16.24 +474 2 7.56667 18.3008 1.17772 -1.22407 -7.09592 -6.98677 +475 1 1.89335 12.9293 13.6081 -2.83392 -4.38044 7.70492 +476 2 1.42634 12.2947 14.1785 7.13969 5.03303 -2.73416 +477 2 2.14611 13.6729 14.1857 -2.01709 -2.63559 -9.61881 +478 1 9.71667 6.79197 14.8165 -19.737 27.0922 8.68981 +479 2 9.89359 5.91802 15.1417 7.60675 -24.7177 2.15595 +480 2 10.032 6.8882 13.9194 5.10262 -3.22926 -9.37061 +481 1 15.2334 4.35765 10.7756 -27.5978 -16.2477 -22.3588 +482 2 16.1684 4.22394 10.6591 16.9939 1.30069 13.5789 +483 2 15.041 5.04225 11.4098 10.4595 11.1452 11.1309 +484 1 11.214 6.13659 0.181715 -19.0514 -14.6776 -12.5318 +485 2 11.2124 5.17659 0.0304417 14.0569 6.29109 5.62342 +486 2 10.2823 6.34718 18.6411 6.7491 10.3457 6.1137 +487 1 0.148583 11.3373 15.1258 -19.5821 15.0001 -24.2151 +488 2 18.1981 11.6758 14.382 16.6378 -5.64999 24.2973 +489 2 18.7581 12.0391 15.8029 -7.9684 -6.15355 -5.02438 +490 1 7.07881 9.17505 7.27008 -6.43803 -1.74166 -4.58486 +491 2 6.45798 8.45812 7.48524 7.10939 3.15379 4.24177 +492 2 7.95401 8.76045 7.26417 -3.66954 2.28396 2.09633 +493 1 18.4168 15.4276 12.3546 -3.43386 -0.549873 -4.48624 +494 2 0.729474 15.5504 12.2627 0.527014 -4.05801 2.94094 +495 2 18.0745 15.7474 11.5108 -2.98934 0.409485 0.218187 +496 1 16.554 4.36499 5.23729 20.8954 -6.05263 25.9175 +497 2 16.7683 4.14077 6.16822 -16.8827 1.59137 -12.628 +498 2 17.4495 4.42836 4.87212 -5.6372 6.04853 -15.3532 +499 1 17.7678 3.07292 10.7257 -2.33819 12.1961 -2.64827 +500 2 0.05876 3.27172 10.9273 -5.50289 -7.01135 -0.383438 +501 2 17.6798 2.21428 10.2822 5.02163 -0.151153 2.81987 +502 1 12.2925 0.0394171 10.1485 -5.03026 26.5344 11.6637 +503 2 11.4572 0.407352 10.526 9.87088 -12.259 -12.5756 +504 2 12.9102 0.803778 10.1803 -6.63246 -15.2789 0.0865208 +505 1 10.3587 9.80679 12.3603 15.6128 10.3756 0.750657 +506 2 11.1656 9.89562 12.9016 -9.14674 -1.49827 1.04164 +507 2 10.2822 8.8615 12.2126 -4.78815 -8.04326 1.85351 +508 1 0.512396 2.83902 7.01376 3.84696 0.0782361 15.1378 +509 2 0.640445 3.53836 7.66576 0.959953 5.26089 -8.6545 +510 2 0.680944 2.06786 7.56376 2.06531 -6.50055 -6.8896 +511 1 0.435055 15.2675 6.92024 15.2549 -35.398 4.87844 +512 2 0.621058 15.2814 7.87767 -6.30652 4.63478 -5.55491 +513 2 0.767833 14.3496 6.68755 -16.1257 30.2961 -2.9732 +514 1 16.9932 7.01767 15.3053 -26.5651 1.45521 -6.17716 +515 2 17.7481 7.60304 15.1777 11.1425 -6.61607 -1.97906 +516 2 17.2478 6.0923 15.4082 16.5215 2.79636 5.68328 +517 1 9.018 12.4253 8.12635 6.95093 19.302 15.9025 +518 2 9.42759 11.8305 7.48541 -10.9396 -6.20971 -13.8418 +519 2 8.05723 12.5431 8.02215 9.94353 -10.4145 -8.12359 +520 1 1.2603 1.92339 3.03777 4.00037 -11.2111 -0.333139 +521 2 0.985763 2.4239 2.25859 3.27899 1.87382 4.37683 +522 2 1.94434 2.40743 3.53125 -8.95634 4.24445 -6.71947 +523 1 4.13152 15.1081 9.6737 -15.9579 5.42681 13.2475 +524 2 4.06185 15.276 8.72578 6.37214 -2.02945 -0.454299 +525 2 5.01049 14.775 9.87491 6.77649 -3.08542 -5.82222 +526 1 7.18656 2.18024 14.5742 6.63684 0.423238 1.66106 +527 2 6.97291 1.78224 13.7284 -0.102066 -5.66692 0.745345 +528 2 7.71431 2.94579 14.3335 0.160548 4.26015 2.86325 +529 1 18.6004 14.6938 2.16823 2.76542 -5.02319 -0.780568 +530 2 0.802927 15.1539 2.18876 5.80577 -4.93168 -0.456722 +531 2 17.9585 15.3989 2.13554 -15.1748 6.08707 3.47143 +532 1 9.94779 2.77101 12.9402 13.7079 -4.8088 0.992354 +533 2 9.86912 2.18708 12.1681 -6.43941 0.85112 1.08944 +534 2 9.26112 3.44421 12.9098 -9.63803 -0.00730006 -3.05418 +535 1 2.82654 8.93218 13.0337 -16.8853 -9.00607 0.122573 +536 2 3.25687 9.752 12.7946 6.59476 15.835 -2.70012 +537 2 3.50997 8.32082 13.3007 12.5319 -6.06263 8.37491 +538 1 3.22862 8.37837 3.65188 -0.226515 1.69475 29.0088 +539 2 3.688 9.03214 3.10752 1.26352 6.15003 5.24259 +540 2 3.37942 8.56962 4.62044 0.873457 0.138782 -29.442 +541 1 5.6209 7.19208 8.52428 9.74274 9.28918 -7.76376 +542 2 5.82768 6.24803 8.58864 -11.1579 -1.95789 2.42461 +543 2 4.98617 7.45468 9.2041 -0.288223 -8.23268 4.91577 +544 1 14.8711 1.29057 2.00464 8.31119 17.2873 -6.28041 +545 2 14.835 2.11415 2.48745 -9.33397 1.40045 17.6104 +546 2 15.2356 1.62076 1.17953 -0.998754 -14.9614 -12.238 +547 1 8.25883 15.2026 0.830681 5.29747 -5.49957 9.6471 +548 2 8.95156 15.1522 1.50066 13.8019 -1.55539 -6.59484 +549 2 7.5748 14.6468 1.22478 -8.81297 0.605757 -6.77665 +550 1 15.6232 1.34362 7.23598 -18.647 -1.91314 -11.6656 +551 2 14.9897 0.764646 6.76092 12.0508 5.58891 7.1025 +552 2 15.1447 2.18632 7.33027 3.5178 -4.19741 5.22167 +553 1 4.94904 13.0769 18.5237 9.6722 0.589191 0.374268 +554 2 5.36668 13.208 0.749415 -4.04426 -2.7658 -6.21312 +555 2 5.63686 13.3362 17.8955 -3.04446 1.7017 1.4528 +556 1 15.3696 8.47999 18.1528 -1.21138 17.1653 -12.6794 +557 2 15.695 9.10606 17.469 -1.13375 -12.9806 6.06144 +558 2 15.1122 9.07709 0.225504 3.72099 -3.98362 5.25331 +559 1 12.0892 3.03182 18.3639 -14.1234 30.4246 -7.06661 +560 2 12.0418 2.65673 0.600248 11.0312 -14.2758 -1.1161 +561 2 12.4684 2.43863 17.7097 5.58993 -13.4699 6.64437 +562 1 13.2076 12.6677 5.18878 -11.1257 12.6934 -18.8931 +563 2 13.6382 11.873 4.85103 6.50507 -2.50005 7.23376 +564 2 13.4408 12.7972 6.11334 1.90386 -8.97209 5.02297 +565 1 6.04179 7.07685 0.0416979 2.64097 -12.2137 0.441028 +566 2 5.97681 7.98433 18.9573 -0.86164 23.926 -2.06041 +567 2 5.22747 6.68409 0.369779 -2.28588 -4.24693 2.31783 +568 1 17.7316 15.9939 15.0114 -15.9363 1.83518 -2.01139 +569 2 16.8954 16.4456 15.035 -7.98632 8.38962 22.0218 +570 2 17.7728 15.8943 14.0703 21.4922 -14.9825 -23.1623 +571 1 13.1856 0.993654 16.5812 4.51688 -6.04585 -7.39508 +572 2 14.1484 0.841574 16.6066 -7.22778 -1.30407 6.3933 +573 2 12.7998 0.141541 16.3207 3.39554 1.08214 8.76474 +574 1 11.0918 14.5789 7.23122 -0.0827639 9.53574 4.16562 +575 2 10.4295 14.1218 7.74457 -13.7426 -4.81361 3.6986 +576 2 11.9118 14.1808 7.52276 7.59678 -9.08814 -4.3045 +577 1 17.5016 8.6119 2.09076 15.8147 11.2146 7.10458 +578 2 16.6678 8.4072 2.52184 -8.49554 -5.1851 -0.954934 +579 2 17.6089 8.02126 1.34907 -7.08963 -15.2245 -7.94382 +580 1 12.3468 7.97644 1.98939 8.16003 1.60059 13.0036 +581 2 12.1059 8.91014 1.92161 -4.12319 -5.14517 -8.91961 +582 2 11.9653 7.48445 1.25112 -3.43761 0.267259 -0.201848 +583 1 11.9018 14.6174 10.3415 -1.61415 6.01794 0.545715 +584 2 12.1103 13.7968 9.87035 -7.85836 7.68399 3.13223 +585 2 10.9576 14.8558 10.2015 13.8599 -12.9225 1.87067 +586 1 6.88302 7.0351 15.5985 0.0361083 -3.88964 -3.36213 +587 2 7.78537 7.14813 15.233 -9.24764 2.66089 10.2853 +588 2 6.74206 7.63616 16.3488 6.91006 -2.15529 -8.72434 +589 1 7.99721 4.71198 13.4628 5.66523 -8.00363 0.660216 +590 2 7.27921 4.81457 12.8289 -1.54019 0.966988 -4.0678 +591 2 8.48375 5.53924 13.4635 -1.88422 3.21799 -0.709238 +592 1 13.4036 12.1691 14.2716 3.14721 5.94494 7.46154 +593 2 13.2707 11.2057 14.207 -2.45791 4.15826 -3.3873 +594 2 13.8696 12.4652 13.4742 -1.1423 -6.74147 -2.23487 +595 1 14.8179 9.43426 7.29668 -6.36233 -11.9657 -8.30628 +596 2 15.5946 9.98871 7.43973 -1.00608 2.08043 5.84882 +597 2 14.0417 9.81939 7.70717 2.29675 7.38462 3.05591 +598 1 12.6631 17.0342 3.08686 -0.647851 26.0284 13.2632 +599 2 13.0189 17.4392 3.9047 -6.62985 -13.126 -8.67274 +600 2 12.0984 17.7464 2.72355 6.77056 -16.0012 0.625123 +601 1 1.16659 7.14982 17.4488 -22.2539 0.168591 -14.6305 +602 2 0.289944 6.86023 17.7803 4.99818 12.4666 0.0121858 +603 2 0.976074 7.62854 16.6106 6.60301 -8.93429 9.27073 +604 1 12.7913 5.13723 15.6659 26.8924 -5.83385 4.65231 +605 2 13.5397 4.50448 15.7352 -14.8898 5.20509 -1.35689 +606 2 13.2524 6.00122 15.6738 -9.3883 -7.24139 -3.09335 +607 1 2.50717 3.39641 5.02544 -4.94238 4.99772 43.075 +608 2 1.86502 3.10611 5.74586 16.3729 8.7954 -24.7542 +609 2 3.07143 4.08677 5.47722 -17.3542 -15.0389 -19.8763 +610 1 8.33721 11.2536 13.4671 -31.8218 12.3906 11.8554 +611 2 8.27902 11.0779 14.4347 20.4393 -8.01279 -19.4916 +612 2 9.11607 10.9377 12.9927 6.53682 -12.2231 14.6875 +613 1 12.8982 1.36842 13.3393 -2.38428 13.9081 -24.9925 +614 2 13.3657 1.32357 12.4816 4.13856 -5.14841 14.3736 +615 2 12.4149 2.20238 13.2267 1.28817 -6.58848 11.7421 +616 1 6.36101 13.6632 2.13728 5.84509 3.64922 20.165 +617 2 5.80267 14.0802 2.81815 -1.42815 -2.61112 -9.48922 +618 2 6.96781 13.1347 2.6793 2.58248 -4.73497 -8.11447 +619 1 15.9275 6.58906 12.776 -13.2255 -11.9143 -7.63467 +620 2 16.5079 7.05171 12.1721 3.66176 7.36442 -5.52267 +621 2 16.2877 6.70509 13.653 8.87525 3.50761 9.55012 +622 1 16.8403 0.7053 9.59425 -10.8287 -6.51914 0.180126 +623 2 16.6786 18.4058 9.8215 7.5744 10.512 -7.34073 +624 2 16.3431 0.86575 8.76743 6.96547 -2.88011 1.97602 +625 1 6.14042 11.7236 8.37935 -13.4401 -40.1875 -12.4491 +626 2 5.21965 11.5178 8.67227 17.9013 7.59491 -1.88002 +627 2 6.47134 10.8481 8.01351 -3.81201 28.7474 13.2691 +628 1 2.85976 8.65216 0.41009 29.1416 -12.2873 -0.261225 +629 2 2.35956 8.19684 18.3517 -12.3126 13.3733 12.5274 +630 2 2.40304 9.34487 0.902258 -18.8466 -1.4582 -10.1697 +631 1 10.1473 10.4614 6.51315 3.14709 -2.48115 -1.63688 +632 2 10.5898 9.76783 7.02035 -1.8228 -0.602608 0.477386 +633 2 10.6086 10.4674 5.65949 -3.20151 3.83187 3.87642 +634 1 6.7508 15.7003 6.55579 -3.66232 16.9823 8.74149 +635 2 7.17195 16.1106 7.3235 -0.889674 -7.99055 3.10182 +636 2 6.78205 16.4211 5.90999 7.33374 -8.97986 -9.58603 +637 1 6.44532 13.1371 5.60194 -4.00449 -9.15456 -0.382904 +638 2 6.60496 14.011 5.98141 3.67218 -1.64471 2.17047 +639 2 6.02503 12.5975 6.28414 2.5909 4.19611 1.89612 +640 1 16.8064 12.5561 9.82402 0.581653 -6.91502 5.14494 +641 2 16.9779 11.8749 9.14515 -1.61791 10.9714 -1.54419 +642 2 16.8208 13.4318 9.41997 2.06437 -4.78596 -5.13994 +643 1 6.05928 2.9442 2.82556 1.25802 -7.30262 2.82421 +644 2 6.27309 3.83898 2.57954 7.79966 17.9541 1.71249 +645 2 5.71238 2.57735 2.0082 -4.75947 -10.8151 -3.84195 +646 1 10.8984 3.29285 3.29228 5.15622 -3.79068 5.20633 +647 2 10.3299 4.01236 3.59418 -0.748764 -1.25701 -6.51467 +648 2 10.5397 2.95527 2.46424 -5.70132 0.188995 -0.608043 +ITEM: TIMESTEP +30 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.74009 7.04233 17.938 19.1777 -3.19214 -7.49225 +2 2 7.80649 7.00854 18.1244 -14.093 -2.50808 3.42214 +3 2 8.91581 6.41795 17.2214 -5.10918 0.448792 4.2696 +4 1 18.6171 8.27942 6.83462 -12.32 14.9255 -3.46236 +5 2 0.0642234 8.14825 5.88022 8.8384 -8.96826 -1.74433 +6 2 0.471057 7.61284 7.31078 8.78566 -8.6497 2.36561 +7 1 8.41948 18.604 6.83196 -7.31709 9.89495 0.0475112 +8 2 9.31705 0.18142 6.57583 5.64527 1.22556 -0.782264 +9 2 7.87491 0.677395 6.4693 3.49499 -4.79599 0.294282 +10 1 6.58709 1.81441 11.6738 -9.76955 10.2882 13.9968 +11 2 5.91112 2.25954 12.2323 7.89399 -9.20897 -13.0604 +12 2 6.23103 0.933026 11.5157 -4.21921 -5.78552 -0.720022 +13 1 7.09426 5.71845 2.37594 5.34919 -15.1759 8.94595 +14 2 6.67772 6.26147 3.06365 -7.93287 1.62685 -13.8275 +15 2 6.91151 6.0744 1.49958 -5.30903 10.9181 0.766926 +16 1 16.2033 10.1932 16.1102 25.1038 -14.8345 -4.68499 +17 2 17.1811 10.2276 15.9712 -26.7737 6.31541 3.48142 +18 2 15.8826 11.0697 16.3304 -0.495148 7.87416 1.92317 +19 1 10.6275 14.9681 2.33481 4.63974 12.4061 -8.88569 +20 2 10.5525 14.5877 3.21874 0.475518 -3.93386 2.29786 +21 2 11.1735 15.7673 2.45016 -5.17002 -7.496 3.37274 +22 1 17.1558 8.25893 10.4932 -6.40301 -0.466841 8.61163 +23 2 16.8014 9.01233 11.0035 2.41501 -9.01393 -1.96838 +24 2 17.9838 8.5563 10.1014 3.2569 5.37409 0.738347 +25 1 14.813 15.8567 16.3841 0.422148 6.97991 -3.34819 +26 2 13.9021 16.1825 16.382 -1.86689 -1.60487 0.125842 +27 2 14.9304 15.3999 17.2268 -3.27081 -1.81494 5.72738 +28 1 12.1434 13.4089 0.461034 6.76243 -11.3039 1.90058 +29 2 12.0273 13.3364 18.1404 -4.47443 10.9984 5.76772 +30 2 11.5266 14.0334 0.870976 -2.78837 -1.53089 -3.65161 +31 1 9.27697 5.43199 4.02458 -7.91052 -7.29997 -7.2337 +32 2 8.84655 5.10212 4.83549 0.848683 4.58319 -8.36746 +33 2 8.59135 5.35221 3.31849 12.3251 4.32217 11.9863 +34 1 1.81829 4.21991 11.6429 6.07059 -17.107 12.3126 +35 2 1.72876 5.16246 11.8251 -3.56412 5.27463 0.970751 +36 2 2.25117 3.81723 12.4298 -6.51129 5.35444 -16.475 +37 1 2.00161 6.82001 8.34658 4.25884 -4.64897 6.26816 +38 2 2.3883 7.2423 9.12712 0.123274 4.2764 -6.11357 +39 2 2.06217 5.87963 8.57415 -6.89287 0.824976 -4.38383 +40 1 5.40511 4.42179 7.95561 5.36611 -11.1614 7.9457 +41 2 5.37943 3.4545 8.00651 8.07147 0.734095 -1.60012 +42 2 4.74745 4.62621 7.29567 -7.31573 12.7226 -8.35968 +43 1 3.27976 2.92717 17.5269 -2.61436 17.3567 -5.43199 +44 2 3.96706 3.40529 17.0145 -5.77518 -10.9103 1.73426 +45 2 2.73687 3.63363 17.9263 6.62302 -5.15647 1.61932 +46 1 7.46558 5.28438 6.08942 -8.18758 20.8516 25.3808 +47 2 7.86532 6.07017 6.49581 9.60667 -5.12281 -7.79846 +48 2 6.93507 4.98822 6.84771 -4.13165 -15.5457 -12.384 +49 1 9.77734 7.00329 11.9774 4.77277 1.25087 12.6605 +50 2 10.3838 6.43919 11.4894 -2.2356 -0.795019 -4.50196 +51 2 9.03042 7.20515 11.401 -0.391647 0.322053 -6.58611 +52 1 14.0794 3.58589 8.07965 12.1281 -3.68665 15.0324 +53 2 13.9224 4.24013 7.41233 -5.94016 13.6931 -8.832 +54 2 14.4997 4.05823 8.8235 -7.49262 -7.6028 -6.06268 +55 1 4.66909 17.2524 3.98463 -11.974 -6.63251 3.44703 +56 2 5.54996 17.5659 4.2137 3.76078 6.9996 -9.15965 +57 2 4.29017 17.6906 3.19701 6.52868 -0.394456 6.67531 +58 1 16.4992 16.6027 10.1206 -21.6924 9.71885 22.6747 +59 2 15.7868 16.8403 10.7484 14.9981 -6.02669 -3.77625 +60 2 16.0155 16.0666 9.49209 1.7904 -6.99745 -11.6514 +61 1 1.97502 4.88502 0.412911 -0.608987 3.87721 -1.07962 +62 2 2.72637 5.27959 0.897705 -7.05745 -2.41863 1.64934 +63 2 1.49341 5.65258 18.7073 9.30006 -4.776 -0.647009 +64 1 11.7125 13.3331 16.298 -5.19121 -16.9939 -9.12414 +65 2 11.2215 12.495 16.3147 -7.17559 5.00423 10.7559 +66 2 12.3053 13.159 15.554 3.20757 8.82206 0.62976 +67 1 10.1364 11.0457 16.9267 -8.25027 -0.64471 -2.79768 +68 2 10.5138 10.1546 16.8726 -0.811727 0.343111 1.84422 +69 2 9.16904 10.9405 16.8614 10.4447 -1.98124 -2.23602 +70 1 11.7196 17.4866 13.4532 0.688277 4.88805 11.3616 +71 2 12.4565 17.1915 12.9059 2.31052 0.20251 -3.63622 +72 2 11.8417 18.4468 13.5823 3.75325 -8.25615 -8.02045 +73 1 6.38436 9.31353 12.2227 -10.6166 9.98881 15.1897 +74 2 6.82973 8.96514 11.4526 14.2312 0.227315 -7.303 +75 2 6.92633 10.0292 12.607 -0.115112 -8.7725 -6.80594 +76 1 16.2215 12.7689 2.69197 14.2202 2.36446 -2.70282 +77 2 17.0315 13.2181 2.42332 4.27042 -4.81366 0.268886 +78 2 15.6299 13.4985 2.86911 -16.5638 6.55953 0.86202 +79 1 0.643858 12.5819 5.90471 10.4355 0.0636689 -1.96923 +80 2 0.972356 12.3928 5.01972 -0.601341 2.21783 -2.79245 +81 2 18.3387 12.6591 5.78833 -5.81166 2.35718 1.0682 +82 1 5.2154 16.4273 18.4533 5.05017 -7.28804 7.26993 +83 2 5.85096 15.759 18.1791 -0.38035 -3.88529 -12.2081 +84 2 5.53459 16.6741 0.678671 -3.42073 7.449 3.19712 +85 1 0.551654 7.64481 4.10641 16.2354 21.1246 -10.5626 +86 2 18.6183 7.98546 3.39603 3.07966 -1.83327 6.1622 +87 2 1.42708 8.08449 3.93576 -19.267 -16.5837 1.18512 +88 1 3.12227 8.91534 6.50802 24.2291 -0.585626 7.1452 +89 2 3.7382 8.63748 7.22391 -17.1573 3.17125 -13.7643 +90 2 2.22482 8.81583 6.82729 -5.68465 -1.73896 5.22193 +91 1 7.30086 10.3189 16.2323 -15.6545 -0.122126 6.34207 +92 2 6.59019 10.5178 15.6183 5.33711 0.792532 -4.64 +93 2 6.81196 10.2023 17.0683 9.00195 1.1125 -0.831229 +94 1 11.1139 1.03369 5.01342 4.3303 1.68398 -12.6705 +95 2 11.3068 1.80352 4.46111 -2.07011 7.18197 9.97137 +96 2 10.7762 0.428462 4.34613 -4.44642 -9.51924 3.00218 +97 1 4.39584 2.7383 13.2149 -0.390466 4.89753 -17.2666 +98 2 4.70663 3.24132 13.9776 -1.24631 -10.9908 10.3904 +99 2 4.24133 1.79775 13.4334 4.65854 7.0575 9.14841 +100 1 8.38523 10.0971 1.80824 -1.28714 19.1329 -0.644156 +101 2 8.30354 10.8052 2.48172 0.822207 -7.93375 -7.37013 +102 2 8.79223 9.36658 2.27287 1.71369 -9.23717 4.71722 +103 1 10.4729 1.73916 15.5717 11.6995 -6.53653 -13.4069 +104 2 11.3877 1.45477 15.4183 -5.50109 4.13915 12.9036 +105 2 10.2466 2.11684 14.7151 -9.31794 0.949785 -3.28817 +106 1 2.72932 12.8923 7.77007 2.13638 -2.03638 4.95693 +107 2 3.24355 13.6603 7.47881 -3.48119 -3.6232 -2.9431 +108 2 2.14523 12.6528 7.03806 -2.13852 4.70731 1.87174 +109 1 3.67999 11.6951 5.25129 1.06179 2.30609 -7.65488 +110 2 3.48397 10.8814 5.71277 1.07183 -5.39866 6.20843 +111 2 2.98047 11.7882 4.59744 -0.426908 3.81831 -2.62473 +112 1 6.82829 14.472 16.8976 7.24547 -11.7087 -0.510459 +113 2 7.70535 14.0752 16.845 -3.98439 5.03843 1.85271 +114 2 6.50852 14.4918 15.986 -3.30226 9.38599 0.302494 +115 1 14.1912 14.5549 3.37889 -4.65321 -1.5346 -2.40618 +116 2 13.6567 15.3531 3.27958 4.16996 -0.562804 -5.50008 +117 2 13.6356 13.9417 3.87468 5.16163 -0.564442 6.07906 +118 1 8.32326 18.1549 16.0383 38.0123 0.723105 5.33509 +119 2 8.90126 17.4596 16.3629 -14.277 -18.5473 4.85232 +120 2 9.02384 0.130446 15.7883 -15.867 17.9211 -5.43461 +121 1 4.72767 1.62379 4.93271 -17.6379 -0.985038 1.9521 +122 2 3.81401 1.95679 4.84992 11.4813 -1.52324 3.97162 +123 2 5.23321 2.13073 4.30096 3.99283 5.81443 -10.8958 +124 1 15.0185 12.7583 16.4307 33.5549 -15.7429 -8.88385 +125 2 14.6322 13.2399 17.156 -17.5625 6.9837 5.99474 +126 2 14.4538 12.6352 15.6516 -10.3238 6.55553 8.00439 +127 1 15.7718 18.4254 16.841 -12.0797 -5.1952 -2.21012 +128 2 16.3284 18.515 17.6327 0.946096 -4.9786 -5.09166 +129 2 15.4084 17.517 16.8347 11.7053 8.22526 2.07191 +130 1 1.18057 1.17309 16.5558 11.0398 2.91722 -0.500753 +131 2 1.84524 1.84688 16.7601 6.86303 -5.43895 -3.7977 +132 2 0.618264 1.22767 17.321 -11.8887 1.06625 6.89733 +133 1 18.1125 4.54155 15.913 0.560198 2.18648 6.37111 +134 2 18.4591 4.08913 15.1466 2.75843 -6.08521 -5.17788 +135 2 18.7597 4.4472 16.6204 -1.36812 0.49592 -3.69459 +136 1 12.2402 16.9779 16.1352 2.31512 -6.99762 -15.3414 +137 2 11.5952 16.4515 16.6081 -8.3163 0.999648 8.5775 +138 2 12.0081 16.8315 15.1982 2.22798 9.47321 6.13039 +139 1 15.9623 2.53119 18.0207 2.93621 -4.28086 -0.122131 +140 2 15.5695 3.22825 18.5544 -2.43998 7.63429 -5.2422 +141 2 15.6676 2.68289 17.1026 2.19807 1.36349 7.25858 +142 1 6.70368 13.8359 10.2288 1.24588 -18.109 -1.49583 +143 2 6.57782 13.5214 11.1319 -1.51171 6.96132 4.85856 +144 2 6.68827 13.0063 9.72453 -2.19505 9.55036 -5.72862 +145 1 10.1309 18.2871 2.76796 -14.3596 -6.47533 0.342864 +146 2 10.2029 0.342366 2.11266 2.51428 7.52943 -3.11917 +147 2 9.22516 17.9366 2.63576 15.7336 3.88756 2.50188 +148 1 2.99532 17.7363 6.09725 27.6457 -0.367768 9.57951 +149 2 2.17297 17.7876 5.61616 -10.9588 -3.8104 -13.5012 +150 2 3.724 17.7747 5.44639 -16.7072 2.57282 0.579206 +151 1 12.5761 16.9143 8.00615 -13.9856 15.3012 3.95273 +152 2 11.7456 16.4539 7.8426 4.73348 -10.9119 -5.17088 +153 2 12.3021 17.5765 8.66814 13.2598 -3.61726 -0.932189 +154 1 14.882 15.2803 8.24971 10.681 -0.761738 -5.80123 +155 2 14.3225 16.029 8.07669 -22.8014 8.12514 9.31404 +156 2 15.4227 15.298 7.45407 7.11517 -7.78554 -3.15381 +157 1 17.6329 18.2578 0.365715 -0.853361 22.9802 4.00517 +158 2 18.5235 17.9699 0.161776 5.93848 -16.2402 -3.481 +159 2 17.7627 0.512218 0.708086 -5.13428 -6.58263 -1.39758 +160 1 0.88251 10.4012 1.38524 10.7451 13.2218 -5.20703 +161 2 0.0659506 9.93794 1.52098 -14.8693 -14.1338 10.0664 +162 2 0.630973 11.1288 0.804044 1.28572 5.25949 -2.19783 +163 1 1.64115 12.2217 3.35193 -3.18006 -13.1055 -18.8251 +164 2 1.37082 11.5062 2.75067 2.88651 -5.3868 11.6868 +165 2 1.67765 12.9428 2.72371 4.09986 15.3051 6.03005 +166 1 0.58147 17.2398 4.87485 -10.389 -0.219728 20.623 +167 2 -0.122589 17.8866 4.86961 1.40048 11.6397 -9.93657 +168 2 0.410626 16.8027 5.7206 11.49 -10.3372 -7.14723 +169 1 1.11352 0.964392 9.43077 -4.94184 3.64088 -20.8453 +170 2 1.20387 0.588778 10.3126 -0.847456 -3.79009 5.67247 +171 2 0.226103 0.72639 9.1141 8.25621 -1.04795 9.52173 +172 1 16.7603 2.33922 13.2874 -3.33679 -13.7714 7.5216 +173 2 16.8475 2.59005 12.3669 3.49604 3.27514 -7.50745 +174 2 16.539 1.38388 13.2956 1.74648 12.4468 1.52133 +175 1 2.56382 15.8252 12.169 -1.32309 5.18512 -19.2115 +176 2 3.14843 15.408 12.7949 3.95332 -3.2625 9.96296 +177 2 3.02181 15.7534 11.31 -3.03818 -3.40517 4.91625 +178 1 16.4251 15.6276 5.98753 2.75225 -2.61515 5.58966 +179 2 17.3447 15.6415 6.33695 -10.8386 4.94036 -7.12539 +180 2 16.2312 16.4474 5.48017 12.4296 -10.8984 6.26847 +181 1 5.80144 5.06794 11.7894 5.49032 -3.99323 1.93812 +182 2 5.42192 5.63452 12.4754 -2.65214 7.25607 -4.62846 +183 2 5.38258 4.20716 11.9011 -4.64894 2.39601 -1.00669 +184 1 15.1781 4.86184 0.728524 -4.34825 6.76152 14.6306 +185 2 15.2668 4.67158 1.68153 -8.60174 -1.32446 -9.75027 +186 2 14.3367 5.34751 19.2902 10.4034 -8.61994 -3.37533 +187 1 16.3306 16.3549 2.10387 -3.60874 -8.17165 19.4202 +188 2 16.1436 16.7757 2.96383 0.821724 -8.86269 -6.10473 +189 2 16.4161 17.1032 1.53428 7.22132 12.8567 -17.8694 +190 1 0.267773 4.86229 3.80408 10.7738 -14.2237 3.39069 +191 2 0.48911 5.8014 3.76313 1.80944 1.44211 5.87769 +192 2 1.0394 4.38382 4.18029 -13.1099 14.4171 -4.44332 +193 1 2.95694 15.0447 15.0954 -6.10325 -16.3486 9.96696 +194 2 2.71126 14.628 15.9563 6.59243 11.9398 -10.1751 +195 2 2.48371 15.8886 15.0723 0.827451 0.569437 4.39106 +196 1 1.13642 14.6155 9.54099 -48.9591 -6.29818 10.1377 +197 2 2.0574 14.6763 9.37448 31.1561 -9.052 1.81392 +198 2 0.917533 13.7788 10.0133 17.9146 13.2649 -10.59 +199 1 13.6267 16.618 11.5309 -14.0517 -2.94194 4.54584 +200 2 13.2284 17.3872 11.0909 1.36391 -4.96948 -3.72009 +201 2 13.0435 15.8681 11.2876 10.4622 6.11411 -5.34277 +202 1 4.69594 1.47637 0.748111 -12.1621 -0.739309 -0.414133 +203 2 4.0907 2.00679 0.20438 8.77888 0.173625 -0.66482 +204 2 4.10511 0.858084 1.19895 3.99089 -4.2391 -0.703649 +205 1 1.43799 18.5334 11.8677 4.48354 -19.5441 -2.70285 +206 2 1.28309 0.34807 12.6964 -2.38454 7.77338 6.6957 +207 2 1.65634 17.6099 12.1011 0.514199 12.3996 -0.852918 +208 1 11.5339 10.1172 4.0507 5.82948 9.6286 -18.4863 +209 2 11.2843 10.5321 3.18756 5.15824 -8.38498 16.2271 +210 2 12.5124 10.093 4.04255 -10.5657 0.881913 4.0585 +211 1 8.32129 12.1582 3.72502 1.53352 8.77417 8.44763 +212 2 9.09494 12.6645 4.01218 5.78128 -3.64141 -7.92941 +213 2 7.76311 12.2518 4.50437 -12.3191 -3.17133 -0.801295 +214 1 14.3738 4.02512 3.28302 13.4457 8.56362 13.3606 +215 2 15.0833 4.15474 3.94873 -8.39321 -4.82495 -4.85792 +216 2 13.6328 4.57269 3.59478 1.91801 -3.79011 -4.78214 +217 1 5.59001 1.69403 7.5104 -22.1497 -9.71937 -16.3739 +218 2 4.92965 1.04535 7.86703 17.0022 15.2682 -3.23125 +219 2 5.33019 1.76513 6.54994 10.6546 -4.2597 24.8978 +220 1 17.8762 1.11593 4.87562 6.9502 3.59021 1.61777 +221 2 18.6375 1.36949 4.33979 -2.23157 -1.53514 -7.48501 +222 2 17.9489 1.70322 5.63717 -7.55192 -1.12522 1.72169 +223 1 6.82082 9.41417 4.48467 7.28036 -1.61815 9.25922 +224 2 6.87733 9.61398 5.42883 -5.7945 0.587378 -0.0554941 +225 2 7.74179 9.22243 4.26363 -0.0627487 -3.5933 -6.80471 +226 1 2.67079 14.9403 1.9639 10.8093 -10.5544 22.1131 +227 2 3.25117 14.6591 2.70117 -12.0207 4.93014 -5.95014 +228 2 3.29732 15.1077 1.27121 3.13815 4.27624 -15.5237 +229 1 17.3067 12.913 13.1683 10.6019 -31.6629 4.62367 +230 2 16.4497 13.2737 13.3972 -3.78483 16.2252 -3.80314 +231 2 17.8834 13.5891 12.8053 -8.28955 15.595 1.58636 +232 1 14.9867 10.5664 1.39303 17.3246 -3.28745 6.09509 +233 2 15.5958 11.2392 1.752 -7.58668 -4.78908 -2.0363 +234 2 14.1528 11.003 1.29225 -13.717 8.26159 -1.38466 +235 1 5.69708 6.86241 4.54741 10.2551 2.99419 0.383868 +236 2 6.12873 7.74081 4.58523 -8.39477 -7.3362 -0.690872 +237 2 6.29159 6.23392 4.98874 0.140081 3.89587 3.34658 +238 1 8.04621 8.27418 10.2318 -1.25624 6.00125 -7.48209 +239 2 8.67166 8.94213 9.92965 6.80147 7.39227 7.14523 +240 2 7.62794 8.03247 9.40376 -7.32264 -11.607 2.12748 +241 1 13.4746 18.3625 5.78211 -13.502 7.51331 -2.26288 +242 2 12.7551 0.364455 5.61988 6.67968 -8.24018 -2.37745 +243 2 13.1168 17.8207 6.50434 6.50164 -0.829271 0.111391 +244 1 0.226362 2.58719 0.131375 -15.5932 24.0028 11.6326 +245 2 17.9693 2.93929 18.6394 3.5786 -16.3529 -5.12341 +246 2 0.708035 3.3711 0.44675 7.58398 -8.21165 -4.7522 +247 1 12.703 11.0237 9.75181 24.9284 -7.65781 8.94422 +248 2 11.7937 10.9936 9.46616 -11.7502 -8.38149 -1.23796 +249 2 12.9608 10.1029 9.99094 -10.5021 9.57622 -2.72207 +250 1 0.761974 12.2205 11.0816 -4.15363 -6.09516 -21.355 +251 2 18.4366 12.288 11.0674 3.38909 -0.754442 8.49561 +252 2 1.11175 12.4338 11.9478 -3.68194 5.91832 8.04416 +253 1 5.07253 7.26896 13.4467 3.90397 -0.0234352 3.77117 +254 2 5.61152 7.96046 13.0436 -1.11485 3.21213 -6.58832 +255 2 5.53238 7.13074 14.2827 -1.05457 -4.33313 3.81413 +256 1 1.23629 6.9109 11.8337 28.2892 12.95 23.6673 +257 2 0.51347 7.34016 11.3984 -13.736 7.24235 -8.87687 +258 2 1.75935 7.64669 12.2495 -13.9201 -17.9067 -15.9983 +259 1 15.4873 9.53008 12.3182 -0.383493 4.12812 -8.89679 +260 2 15.0655 10.399 12.2152 3.51435 -2.6855 7.45914 +261 2 15.2649 9.14784 13.1724 -1.90612 6.52608 2.19385 +262 1 16.6085 12.8345 5.46896 -3.55761 11.1023 -1.95777 +263 2 16.4419 13.7896 5.48874 0.313493 -0.193839 12.6146 +264 2 16.4475 12.6632 4.54137 -0.0496347 -14.7353 -8.15109 +265 1 6.20534 9.98194 0.0899104 18.0768 -8.37359 0.258846 +266 2 5.59572 10.4068 0.70246 -2.59094 3.74961 3.89273 +267 2 7.08249 9.9872 0.527613 -14.0474 2.02387 3.58276 +268 1 12.3397 6.07843 4.05984 1.81271 11.939 -8.21694 +269 2 12.2328 6.8085 3.41842 8.48996 -4.45606 3.14495 +270 2 11.4615 5.7138 4.10837 -10.8447 -6.35959 3.05037 +271 1 0.186481 12.7968 0.194157 8.45417 -0.362633 0.823389 +272 2 0.122538 13.4857 0.868002 -3.08717 1.48078 1.57348 +273 2 18.4164 13.184 18.057 -2.66731 -2.48236 -4.34426 +274 1 3.77162 18.5917 8.57827 -20.4554 1.45559 2.68175 +275 2 3.52322 17.9715 7.87805 6.33007 3.25639 -1.82086 +276 2 2.90938 0.367014 8.76804 7.74592 -0.0744794 5.639 +277 1 7.46409 17.2961 4.48316 -14.1198 -17.2275 8.02552 +278 2 7.88946 18.1398 4.59819 4.06261 16.9953 -5.43573 +279 2 7.32948 17.1504 3.54137 6.62361 8.1702 -3.03871 +280 1 9.24056 17.0796 12.2607 -1.29913 -0.841935 -6.42698 +281 2 9.19718 16.4258 11.5387 7.57092 0.344645 9.78983 +282 2 10.1052 16.9888 12.7016 -6.07497 2.05659 -6.06408 +283 1 13.326 12.928 7.96212 4.69357 25.6567 2.07593 +284 2 13.3763 12.2768 8.65803 -4.91574 -13.7878 2.50151 +285 2 13.7353 13.7181 8.35204 8.56042 -2.58857 -8.38859 +286 1 14.9538 2.97298 15.3382 -4.29462 -11.8182 -2.96981 +287 2 14.4639 2.15222 15.1644 -2.78402 11.1896 3.17375 +288 2 15.6292 2.97829 14.6488 1.75 3.70602 0.0805282 +289 1 9.85487 15.5414 16.9955 1.72232 -1.82893 -0.169847 +290 2 10.3837 14.7676 16.7382 -3.42626 -0.271454 1.71497 +291 2 9.29261 15.2923 17.7497 4.44449 2.55726 -1.27949 +292 1 11.3089 8.30526 16.5494 -6.04997 -6.2326 7.21044 +293 2 10.5881 7.89563 16.0543 2.01853 1.78394 -3.12513 +294 2 11.4835 7.65722 17.2517 2.74023 7.81545 -1.84368 +295 1 3.836 18.1836 16.7517 -7.13385 -19.1452 -23.0441 +296 2 4.27407 17.4593 17.223 1.84106 9.67264 7.83483 +297 2 3.88222 0.348533 17.2402 4.94653 11.64 14.7969 +298 1 2.18178 4.13609 8.93005 8.1701 -0.774865 9.73019 +299 2 3.0913 3.90524 8.75773 5.46766 -1.37508 -11.1104 +300 2 2.14869 4.01328 9.88774 -11.2166 4.12208 2.959 +301 1 9.87742 10.3647 9.70242 2.63105 14.1486 10.9213 +302 2 9.56679 11.2208 9.35298 -0.359428 -9.80694 -0.658425 +303 2 10.1334 10.5423 10.6269 -4.00587 -8.10964 -6.10976 +304 1 9.70429 0.823826 10.8553 -14.0108 4.16215 1.0267 +305 2 9.1278 18.77 11.1938 11.0832 -7.32823 7.11532 +306 2 9.14207 1.22722 10.1856 4.51331 8.02138 -6.87563 +307 1 9.20617 15.1402 10.2178 -11.609 -5.72992 -0.101326 +308 2 8.7465 15.767 9.6415 2.03963 4.50002 1.17892 +309 2 8.51696 14.4821 10.4282 6.2553 7.07807 -5.66984 +310 1 0.996164 9.40777 10.3157 -31.4617 35.4735 1.80375 +311 2 1.02993 10.3821 10.3914 -11.0752 -10.4846 4.01107 +312 2 1.89609 9.22017 10.2201 37.6387 -20.6805 -6.1303 +313 1 16.8786 4.85128 8.17759 -11.2506 16.3288 -5.48708 +314 2 16.2388 5.56314 8.38188 8.44756 -9.04525 0.78656 +315 2 16.9626 4.34108 8.98054 4.36808 -7.38136 2.74573 +316 1 14.6815 14.711 0.319263 14.4838 0.937126 -3.06264 +317 2 15.2721 14.9301 1.06391 -7.87321 4.75235 -6.44468 +318 2 13.8763 14.3724 0.714255 -5.91657 -4.41648 2.02008 +319 1 3.57415 11.0448 9.58418 2.91679 3.40936 2.58946 +320 2 3.69173 11.5263 10.4228 -3.34733 -6.02301 -1.37626 +321 2 3.07399 11.6483 9.00652 3.80152 0.245021 0.575116 +322 1 11.1013 10.8086 1.33492 -13.1151 -1.75228 0.351043 +323 2 11.4484 11.639 0.990604 2.68761 3.85867 -0.677593 +324 2 10.1644 10.7789 1.04773 13.6271 -2.80152 6.25142 +325 1 13.1828 7.11823 12.837 13.875 6.93007 -2.08809 +326 2 14.1546 7.00576 12.8731 -8.73741 -0.33434 -1.11439 +327 2 12.8407 6.21951 12.8306 -5.12621 -6.60309 0.0889066 +328 1 9.62491 1.88499 0.973614 -3.42399 -6.06492 -12.2684 +329 2 8.82152 1.4846 0.597998 2.34171 8.22807 3.07369 +330 2 10.1781 2.12743 0.21359 -0.384483 0.556473 6.61436 +331 1 10.6031 13.5334 4.66686 13.636 -3.8461 -1.22567 +332 2 11.4763 13.1252 4.55872 -4.58351 -5.15517 0.0143246 +333 2 10.7077 13.9241 5.53959 -7.66657 9.10334 4.04553 +334 1 14.3485 1.75735 10.9256 -1.10429 -17.7549 1.09656 +335 2 15.1861 1.44338 10.54 -2.80824 6.90847 2.1648 +336 2 14.3834 2.71874 10.9625 8.08978 3.11888 -5.0019 +337 1 14.6333 12.3432 11.6996 -1.39952 -9.16637 -24.1357 +338 2 15.3681 12.4502 11.0746 9.0546 4.11007 14.4837 +339 2 13.9355 12.122 11.0753 -11.0061 -2.1546 9.49113 +340 1 8.24004 5.06512 9.81661 -6.73852 -15.0928 -6.1646 +341 2 7.43321 5.24609 10.2868 -7.68507 10.8263 10.6715 +342 2 8.07004 4.14881 9.53169 13.9201 5.19095 -3.88371 +343 1 1.57861 16.855 18.3455 -3.6047 -18.8696 23.6299 +344 2 1.81992 17.2862 17.5419 10.6717 7.49965 -18.3027 +345 2 1.88846 15.9289 18.2434 -7.51751 10.9825 -1.36554 +346 1 1.48469 17.2399 15.3369 -30.5992 8.85894 1.58219 +347 2 1.52903 18.0991 15.7763 5.64601 2.15314 -3.36931 +348 2 0.515015 17.0623 15.2815 21.6878 -4.25813 -0.913042 +349 1 3.6961 5.66103 6.13276 1.27154 -4.68408 -0.174538 +350 2 3.02861 6.15393 6.634 5.94065 6.05513 -0.564102 +351 2 4.2706 6.29315 5.66099 -8.13711 -1.6893 2.05746 +352 1 12.3863 9.46112 14.1898 5.64676 -22.9439 1.72589 +353 2 12.6155 8.61212 13.7476 3.53191 14.2422 4.21489 +354 2 12.2183 9.16782 15.1036 -0.67103 6.17556 -4.58111 +355 1 4.03262 15.2884 6.88962 -6.96122 -2.16466 3.53978 +356 2 3.61008 16.076 6.4989 3.67472 -5.21865 6.04109 +357 2 4.98914 15.3892 6.82497 3.29203 7.08348 -5.36605 +358 1 0.610585 8.57451 14.9167 2.06858 8.16468 9.66942 +359 2 0.571526 9.5334 15.101 -0.509723 -6.74541 -4.80249 +360 2 1.24768 8.49017 14.2004 3.24343 3.39805 -1.00154 +361 1 12.9947 8.30502 10.3347 -2.10898 5.96297 -3.02925 +362 2 13.7245 7.79451 9.98073 4.34503 -3.62623 -11.9067 +363 2 13.0194 8.04092 11.2546 -7.35013 -0.655157 9.61409 +364 1 15.3021 7.68636 3.53463 20.0464 32.042 -6.64886 +365 2 14.6007 7.2355 3.06802 -7.18972 -17.1123 8.01585 +366 2 15.7144 7.29713 4.32433 -16.1768 -11.7678 -0.766084 +367 1 17.3034 6.68003 0.0493874 -1.84179 -13.5509 -2.88881 +368 2 16.9519 5.78424 0.161568 0.711034 6.10552 3.25575 +369 2 16.5083 7.2036 18.5276 -0.473138 7.46776 -7.84911 +370 1 8.84315 6.93181 7.84628 -0.943806 11.0529 -13.3888 +371 2 9.77771 7.20927 7.80441 -6.03996 -2.82935 4.46193 +372 2 8.74315 6.27043 8.54219 4.24547 -3.80386 5.92931 +373 1 12.3578 0.616451 1.20223 7.02437 -6.39463 -1.478 +374 2 13.2861 0.535705 1.47006 -5.02329 6.70293 3.96338 +375 2 12.2631 18.6802 0.444477 -1.70715 1.25222 -1.43865 +376 1 5.64724 15.135 14.5406 -0.604856 -11.7009 0.79572 +377 2 4.70142 15.1669 14.7844 5.92695 5.15448 -4.69419 +378 2 5.94602 16.0188 14.2721 -2.36621 0.047849 -2.09121 +379 1 3.86203 6.47491 1.73695 1.36817 -0.22553 5.39386 +380 2 3.46749 7.3178 1.48065 -2.80916 3.79134 -8.60259 +381 2 4.09027 6.61791 2.66801 -1.52617 -4.74348 -3.78665 +382 1 3.89615 11.6258 12.3135 -4.96985 -7.23752 -2.42851 +383 2 4.76636 11.9561 12.5635 2.33504 5.86151 0.242199 +384 2 3.23901 12.1927 12.7515 8.69891 -3.88643 -0.482475 +385 1 5.40213 3.8611 15.8693 10.8945 -12.2769 2.09816 +386 2 6.15363 3.21949 15.8699 -18.4435 12.0745 -5.1575 +387 2 5.79254 4.73962 15.8533 3.23601 3.32406 0.742539 +388 1 14.4255 10.2871 4.42158 -5.00773 -17.9107 13.5675 +389 2 14.5181 9.70279 5.20492 2.69814 10.8256 -8.91808 +390 2 14.7837 9.77905 3.68069 -0.206993 2.85241 0.289205 +391 1 7.87167 17.3723 9.20121 -10.8695 6.25183 -3.73994 +392 2 7.03582 17.6433 9.5986 1.28641 -7.15132 6.24862 +393 2 7.9635 17.9776 8.45108 8.3983 -5.79413 -1.77097 +394 1 4.52981 14.473 3.9851 -7.27149 14.4717 16.1092 +395 2 4.4292 15.3844 4.34508 5.86047 -13.4028 -12.5476 +396 2 4.51094 13.8931 4.76638 0.622359 -0.721789 -7.97238 +397 1 14.2548 7.40188 15.768 -9.88191 3.80355 1.83721 +398 2 15.2055 7.32768 15.6782 10.3356 -1.93634 -2.70959 +399 2 14.1214 7.72007 16.6658 2.42251 2.42868 0.921806 +400 1 2.92318 18.2319 1.90056 8.21916 -2.84793 -3.01579 +401 2 2.38261 17.6158 1.3774 3.82694 3.92633 -2.29165 +402 2 2.32657 18.895 2.2462 -10.4983 4.84254 7.82145 +403 1 7.9872 1.59624 4.55123 -13.2342 7.82044 -5.09514 +404 2 7.38456 2.15817 4.04087 -4.12207 -9.74777 1.09289 +405 2 8.829 1.94177 4.28864 19.9647 -0.586446 1.64736 +406 1 2.52886 14.1331 17.7106 9.56011 -8.28606 7.0204 +407 2 2.01365 13.3855 18.0679 -1.20108 10.5585 -3.23507 +408 2 3.45026 13.9294 17.9721 -7.58546 -2.42865 -2.00823 +409 1 0.784808 1.71729 13.877 -22.3729 3.14932 11.7627 +410 2 0.820241 1.39718 14.7912 6.0833 4.21121 -6.47959 +411 2 18.4913 1.99435 13.7832 17.5446 -4.15928 -6.69512 +412 1 4.49906 18.6473 13.9354 -18.7945 1.8826 8.61585 +413 2 5.41644 18.4141 14.0419 11.9469 -5.27484 -6.26214 +414 2 4.07897 18.3597 14.7657 2.79866 5.45516 -5.58976 +415 1 7.09283 0.599142 18.3486 34.6471 -4.12786 -6.63011 +416 2 7.39021 0.234617 17.4878 -9.84259 3.28252 9.67216 +417 2 6.14438 0.553251 18.3894 -16.3447 5.16139 0.014819 +418 1 16.0881 18.4309 14.0453 5.06229 7.716 24.0321 +419 2 15.2482 18.0804 13.8032 -16.2536 -8.6858 -12.6141 +420 2 15.9952 18.587 15.0073 9.58514 -0.127307 -10.5143 +421 1 10.0776 4.50678 16.2676 12.8821 37.0646 3.31891 +422 2 10.9819 4.89306 16.3611 -10.6263 -20.5161 -3.34059 +423 2 10.1424 3.55939 16.3223 6.24363 -16.5382 -1.58612 +424 1 15.8992 17.8398 4.41934 12.2004 7.51097 -4.98004 +425 2 16.3832 18.6941 4.42415 -3.71288 -10.9395 3.02327 +426 2 14.9903 18.0494 4.62819 -9.96916 6.21932 6.5896 +427 1 6.98832 17.3871 13.7576 13.6855 5.49553 14.8404 +428 2 7.37965 17.5993 14.631 -4.71479 -0.449691 -14.3122 +429 2 7.76575 17.2997 13.1656 -13.1106 -1.1113 5.84114 +430 1 13.2824 6.5097 6.67953 4.56939 11.9611 -5.54075 +431 2 14.0532 7.04843 6.47095 5.72005 -2.26771 11.4806 +432 2 12.9258 6.37058 5.8058 -10.6331 -8.36185 -8.97535 +433 1 7.75109 2.3756 9.23631 -5.33505 -3.40336 15.3372 +434 2 7.18759 2.24157 10.0186 8.87424 2.78019 0.355864 +435 2 7.20141 2.0575 8.52046 -4.61968 -0.366971 -12.063 +436 1 15.1734 14.8403 13.6669 0.441467 -1.73197 5.96822 +437 2 15.0738 15.2212 14.5455 0.591215 -4.0348 4.14746 +438 2 14.518 15.2716 13.122 -1.09719 2.73458 -8.10719 +439 1 9.35119 8.31644 3.739 2.66762 7.66889 5.69365 +440 2 10.15 8.71947 4.13947 -5.98752 -7.29531 -6.80605 +441 2 9.38201 7.35632 3.87197 4.69073 2.10751 1.74529 +442 1 17.751 13.5231 16.4139 1.76506 1.52762 0.696064 +443 2 16.8205 13.2419 16.3833 1.32585 7.25436 -2.93419 +444 2 17.8025 14.3962 15.9827 -4.54797 -4.37418 0.927992 +445 1 4.99908 10.6417 2.69781 -10.2301 11.821 9.59097 +446 2 5.61637 10.2237 3.29708 11.0389 -6.03173 2.08237 +447 2 4.70065 11.4181 3.20566 0.509198 -9.80178 -10.0294 +448 1 3.73671 8.33589 10.2301 0.811909 12.56 -11.1256 +449 2 3.79833 9.26935 9.95307 1.30999 -3.93497 -1.66187 +450 2 3.73931 8.38186 11.1831 0.045476 -4.76093 8.99044 +451 1 16.0469 7.05349 6.21752 -8.36922 7.98368 -7.54927 +452 2 16.8656 7.47651 6.4961 3.44749 0.07849 4.67395 +453 2 16.1438 6.1088 6.32704 6.52122 -4.4821 -3.05144 +454 1 15.1289 7.04368 9.08785 10.4694 9.8467 1.75835 +455 2 15.8264 7.38614 9.67453 -3.18259 -3.19274 -6.50653 +456 2 15.1274 7.66298 8.34243 -1.48772 -3.73631 0.00250057 +457 1 6.37899 13.0555 12.8241 7.15095 -9.93714 4.62427 +458 2 7.14263 12.6042 13.2293 -5.49135 0.351509 -10.6671 +459 2 6.23455 13.8287 13.3737 -7.10156 7.81238 6.40695 +460 1 12.1361 4.49173 13.0886 -33.3605 -9.49617 -7.12831 +461 2 12.0495 4.6518 14.0281 12.9755 3.95225 11.8447 +462 2 11.274 4.06082 12.879 23.5373 6.19102 -2.9945 +463 1 11.3516 8.18262 7.87035 -14.4325 7.02786 -3.11936 +464 2 12.0471 7.65769 7.46008 8.6713 -7.43794 3.47117 +465 2 11.5359 8.26397 8.81258 10.0684 -2.50636 2.15934 +466 1 17.1915 10.8124 7.44959 -16.1176 10.6393 13.8832 +467 2 17.9047 10.1798 7.28217 -0.931293 1.13858 -10.0543 +468 2 16.9855 11.3827 6.68215 10.1883 -6.89581 1.62445 +469 1 5.25104 18.1119 11.0466 -2.03712 6.82198 -5.53245 +470 2 4.55844 17.9395 11.7023 5.22213 1.54215 -0.259713 +471 2 4.79647 18.4173 10.2467 -3.05137 -7.80568 1.06144 +472 1 7.59144 17.5428 1.82585 2.02366 6.3387 -27.4892 +473 2 7.8094 16.7742 1.27336 1.17923 0.135637 10.7354 +474 2 7.55288 18.254 1.15356 -7.65387 -5.36774 12.2151 +475 1 1.92063 12.9184 13.6023 -9.91855 -8.75107 -5.23832 +476 2 1.37345 12.2779 14.0844 5.59931 4.65398 4.03533 +477 2 2.08932 13.6638 14.189 3.88592 4.92281 2.07481 +478 1 9.68002 6.79239 14.8375 -5.9785 1.55821 1.53848 +479 2 9.8605 5.87105 15.0454 -1.79232 -6.14635 7.43903 +480 2 10.0701 6.92553 13.9753 -0.129146 4.69231 -11.1498 +481 1 15.2463 4.32976 10.758 3.34542 15.1712 12.775 +482 2 16.1952 4.27653 10.855 10.1577 -17.3864 -7.84826 +483 2 15.0718 4.96713 11.4544 -13.5892 3.80238 -1.28771 +484 1 11.2223 6.14234 0.184515 14.935 15.986 0.702496 +485 2 11.3427 5.2537 -0.179589 -9.34658 -3.11564 3.17557 +486 2 10.3073 6.45674 18.8196 -5.33379 -13.1911 -7.29958 +487 1 0.101128 11.3538 15.0994 -20.5112 19.1646 -16.3994 +488 2 18.0631 11.5965 14.4157 17.8209 -6.40715 11.0417 +489 2 18.7281 12.1498 15.6639 -2.69532 -11.5931 2.167 +490 1 7.07341 9.21118 7.26397 13.6545 -4.38359 1.14819 +491 2 6.46912 8.52168 7.54812 -6.91606 -6.22713 3.38737 +492 2 7.94495 8.78194 7.35853 -7.81842 8.24868 -3.32543 +493 1 18.379 15.4045 12.3485 -3.73833 -6.55761 4.14497 +494 2 0.693581 15.4288 12.2501 6.70794 3.85833 -5.56408 +495 2 17.998 15.8269 11.5664 0.97425 0.444703 -1.66759 +496 1 16.5516 4.36462 5.23826 -5.38189 5.67955 -17.8631 +497 2 16.655 4.28498 6.19256 13.2509 -4.37544 3.08954 +498 2 17.3965 4.59413 4.7818 -8.47419 -6.89051 15.5314 +499 1 17.7443 3.09877 10.7286 3.04827 -10.7181 -6.87848 +500 2 0.0283995 3.26624 10.9392 2.02267 5.05617 3.97045 +501 2 17.7464 2.2027 10.3321 -6.96828 10.7891 3.50943 +502 1 12.2779 0.0212452 10.1338 -0.475788 -3.12763 3.03365 +503 2 11.45 0.377358 10.5143 6.17492 -0.459139 -6.32122 +504 2 12.9469 0.721114 10.1609 -4.48032 5.31969 3.75096 +505 1 10.3747 9.79435 12.3975 0.995366 2.64477 2.84838 +506 2 11.0916 9.86004 13.0462 0.88472 -0.940912 -1.26785 +507 2 10.2331 8.84374 12.2815 -0.892889 0.226532 -0.81052 +508 1 0.549483 2.84316 7.02126 -1.47246 -21.9217 -16.5589 +509 2 0.577314 3.5439 7.66737 3.67317 4.63089 12.4819 +510 2 0.765862 2.00117 7.45653 1.04632 13.6877 4.9994 +511 1 0.405258 15.2829 6.93023 -2.49907 -5.43649 4.98244 +512 2 0.538371 14.8975 7.8327 2.16571 9.44122 -16.3162 +513 2 0.725684 14.6278 6.28848 -1.93707 -3.30699 10.9749 +514 1 17.0129 7.01771 15.2646 8.6122 -7.5627 -5.22629 +515 2 17.8138 7.53109 15.1273 -3.20292 15.4854 -2.58719 +516 2 17.4051 6.15342 15.4314 -10.2841 -6.73634 6.86556 +517 1 9.05466 12.4444 8.11302 13.0521 -10.4864 -20.5516 +518 2 9.3276 11.8473 7.39447 15.1337 1.48797 7.8591 +519 2 8.12011 12.397 7.99286 -24.7878 10.4099 9.23055 +520 1 1.26093 1.88381 3.01396 9.71768 11.5305 -0.318626 +521 2 0.781341 2.25664 2.27301 -4.68813 -2.91629 -4.97973 +522 2 1.78505 2.63319 3.35529 -3.04295 -14.2735 3.58948 +523 1 4.11799 15.1078 9.73252 4.576 2.76804 -1.92408 +524 2 4.09335 15.377 8.80945 -5.53143 0.588802 -2.3225 +525 2 5.02333 14.7824 9.83323 -1.70794 -2.53339 7.76874 +526 1 7.21252 2.18262 14.5895 -3.17269 -14.8219 8.52343 +527 2 7.02371 1.74902 13.748 4.05246 3.09826 3.19753 +528 2 7.71073 2.97164 14.4061 4.58862 11.2949 -7.92291 +529 1 18.5773 14.6793 2.1781 -14.8885 -13.9434 -3.10254 +530 2 0.806981 15.0773 2.13409 4.68638 9.16713 1.06255 +531 2 17.8879 15.3584 2.08187 6.00104 3.32119 3.09374 +532 1 9.95988 2.75708 12.9307 -3.19888 4.8993 -0.068744 +533 2 9.83509 2.14797 12.1955 3.80206 -8.82317 -3.94881 +534 2 9.20326 3.3528 12.8696 -1.08171 3.11286 5.06453 +535 1 2.85334 8.94069 13.0534 -9.07349 -10.7547 -1.24525 +536 2 3.30632 9.75091 12.8027 2.98523 12.1914 -0.768468 +537 2 3.53212 8.32042 13.3313 9.61222 -2.32206 4.81477 +538 1 3.22451 8.40753 3.67121 22.1548 25.1655 0.793749 +539 2 3.78763 9.07745 3.2153 -17.2399 -11.2925 0.757254 +540 2 3.40605 8.58793 4.60238 -4.67213 -6.04062 1.9181 +541 1 5.62069 7.18926 8.53747 6.69229 -2.05947 9.74796 +542 2 5.86853 6.28591 8.76536 -0.744086 -3.6627 -12.9201 +543 2 5.09246 7.43537 9.3012 -7.69944 9.66912 -1.05292 +544 1 14.8771 1.33506 1.99369 -4.37531 -14.3045 14.6387 +545 2 14.6174 2.14132 2.47402 3.99094 2.69357 -12.1219 +546 2 15.1274 1.48157 1.08098 3.94771 15.4277 -5.2716 +547 1 8.29964 15.2018 0.824762 -0.280237 2.12341 -18.5848 +548 2 9.0741 15.0554 1.38374 0.657448 -4.01578 8.69554 +549 2 7.56069 14.656 1.13255 5.04945 -5.16558 7.75703 +550 1 15.6052 1.34643 7.22407 3.75056 4.73875 0.699016 +551 2 15.0587 0.773182 6.67423 -5.35564 1.12746 0.995868 +552 2 15.1053 2.16848 7.37587 -1.8024 -6.33902 1.47434 +553 1 4.99443 13.0609 18.5093 -5.69789 -0.343563 -13.2097 +554 2 5.39232 13.2306 0.720212 5.08054 -1.92613 6.3414 +555 2 5.7137 13.1567 17.8693 -5.50653 4.49423 4.11534 +556 1 15.3782 8.49607 18.1492 -5.08872 -0.806473 3.30258 +557 2 15.7135 9.0139 17.4023 0.0404722 4.09908 2.1153 +558 2 15.1698 9.14329 0.203973 4.81283 -1.94937 -4.21801 +559 1 12.0917 3.05456 18.3485 5.25344 -19.9367 5.19329 +560 2 12.3328 2.56101 0.492796 -7.10973 11.5886 11.7441 +561 2 12.4167 2.41374 17.7115 -1.86526 8.77132 -18.5664 +562 1 13.1991 12.6728 5.17615 -0.124316 -0.0560055 4.18836 +563 2 13.6438 11.8331 5.03438 2.42254 -3.05364 -13.3032 +564 2 13.4089 12.8359 6.10375 -5.84435 4.2533 1.84347 +565 1 6.03469 7.1207 0.0631469 12.4635 -7.18562 -1.52206 +566 2 5.88549 8.01359 19.0305 -4.09863 7.65543 -4.79966 +567 2 5.21365 6.64029 0.190066 -5.29753 1.61074 5.21091 +568 1 17.6997 15.9613 14.987 30.7149 -12.4194 32.4504 +569 2 16.8862 16.4214 15.1458 -18.1669 6.52853 -13.961 +570 2 17.8877 15.7083 14.0822 -14.2113 6.66636 -19.3843 +571 1 13.1806 0.977208 16.5993 3.21446 -7.78263 -3.05852 +572 2 14.1069 0.725878 16.7441 -1.84519 3.55213 2.46319 +573 2 12.7536 0.148831 16.339 0.610986 0.436683 6.04854 +574 1 11.0624 14.5912 7.28204 -11.2181 -3.76258 -2.73638 +575 2 10.3867 13.9846 7.62705 2.11873 3.9908 3.08505 +576 2 11.9143 14.2091 7.50586 0.261112 -7.43153 0.664812 +577 1 17.506 8.58052 2.09005 -0.444247 -11.7988 -12.468 +578 2 16.6642 8.31502 2.4773 -2.50704 5.84538 6.9832 +579 2 17.563 7.99026 1.31874 6.86903 3.37396 8.78538 +580 1 12.3502 7.95652 1.98027 -3.36099 -5.49894 -2.13311 +581 2 11.9195 8.80992 1.98547 0.506131 9.65618 1.3531 +582 2 11.9377 7.50693 1.23044 6.6222 -7.49408 4.60604 +583 1 11.9327 14.6311 10.3511 -13.8226 21.3891 7.58711 +584 2 12.0851 13.8189 9.91206 10.3006 -23.5502 -10.4516 +585 2 11.0014 14.8158 10.1424 3.95037 3.15478 8.54077 +586 1 6.86541 7.01247 15.582 10.3214 -0.24422 -5.9518 +587 2 7.78025 7.06796 15.2658 -3.95377 -6.01896 -2.62563 +588 2 6.83046 7.729 16.2102 -7.67029 5.21932 8.6005 +589 1 8.00165 4.68416 13.4443 -21.8863 -22.7248 -23.0503 +590 2 7.36443 4.84116 12.7101 7.64348 -4.39085 15.7408 +591 2 8.44337 5.50298 13.5544 13.6077 24.8283 3.95349 +592 1 13.4082 12.1692 14.291 7.74384 0.583631 -6.74495 +593 2 13.3391 11.2097 14.1788 -8.03609 -0.555633 4.00216 +594 2 13.8852 12.4587 13.496 -2.17037 2.06617 1.19415 +595 1 14.784 9.43826 7.28323 -11.1269 12.8929 16.9671 +596 2 15.4951 10.0466 7.55684 1.33033 -10.8665 -8.82607 +597 2 14.017 9.71262 7.81429 7.01149 -4.68319 -9.50468 +598 1 12.6837 17.0142 3.10751 10.9269 -13.9095 9.51878 +599 2 12.9708 17.2813 3.99359 -6.48615 4.53386 -3.20168 +600 2 12.1282 17.7068 2.75827 -7.19321 10.5694 -1.73823 +601 1 1.13983 7.14905 17.429 -19.8537 -0.642492 -7.24746 +602 2 0.229092 6.89189 17.6928 9.24629 12.0374 -0.554306 +603 2 1.04788 7.63326 16.5858 1.73105 -6.23108 5.83737 +604 1 12.8283 5.10796 15.6891 -3.1105 -1.51238 -5.72518 +605 2 13.5351 4.46064 15.5231 -0.330328 2.49365 6.49287 +606 2 13.2544 5.98171 15.6287 1.13166 -7.6156 1.26811 +607 1 2.48175 3.38612 5.07416 -11.4746 -6.3359 16.597 +608 2 1.87059 3.13723 5.824 15.2627 10.0051 -19.3068 +609 2 3.07561 4.08306 5.41325 -9.83136 -1.83582 -2.79497 +610 1 8.32062 11.2204 13.4908 14.3326 -12.3724 2.23055 +611 2 8.41586 10.9603 14.3918 -15.5351 3.38632 26.9235 +612 2 9.1195 10.7822 13.1796 -2.73354 4.12568 -26.6086 +613 1 12.9112 1.40899 13.3219 3.38587 -22.7152 11.6955 +614 2 13.5257 1.21801 12.5994 -2.66679 10.6744 -3.40434 +615 2 12.4724 2.23119 13.1327 -1.22779 13.5514 -6.35015 +616 1 6.39925 13.6301 2.14388 13.7527 -0.778699 -6.56015 +617 2 5.84347 14.0897 2.78318 -1.88549 -3.79567 9.96763 +618 2 7.03431 13.0755 2.63977 -7.58465 4.89894 -0.0461429 +619 1 15.9327 6.56061 12.7538 -0.9836 2.19135 -10.6596 +620 2 16.5146 6.98287 12.103 -5.34808 0.40017 1.48081 +621 2 16.2873 6.8165 13.6112 3.99792 -3.90075 7.11277 +622 1 16.8306 0.705066 9.59578 -7.6122 -1.79623 -7.44488 +623 2 16.785 18.3903 9.75048 3.18156 2.06447 -0.865929 +624 2 16.3719 0.843651 8.74144 5.4764 0.262409 5.10626 +625 1 6.12658 11.6826 8.3633 -3.5227 -13.2845 -7.84739 +626 2 5.19255 11.5559 8.64231 15.2704 -3.4985 -2.63712 +627 2 6.45331 10.8168 8.01189 -8.18375 16.1965 9.35276 +628 1 2.85137 8.68091 0.385463 -5.58051 9.89965 12.0536 +629 2 2.19225 8.31695 18.4611 -2.16592 -25.8024 -20.6889 +630 2 2.2971 9.35613 0.77772 10.4924 10.4953 14.3564 +631 1 10.1291 10.4583 6.52809 -2.44089 1.08082 5.72444 +632 2 10.551 9.78353 7.0828 -0.111445 0.581803 -4.14441 +633 2 10.6952 10.5682 5.75546 0.540532 -2.90301 -3.90698 +634 1 6.75412 15.726 6.57209 -8.13971 -2.30487 -2.02419 +635 2 7.24364 15.9641 7.36655 2.15693 7.18823 -0.87292 +636 2 6.8879 16.4298 5.90744 8.86888 -7.67267 7.00242 +637 1 6.43944 13.0908 5.62507 5.5957 4.80241 6.78236 +638 2 6.68766 13.9873 5.91055 -1.86537 -6.12454 -2.89892 +639 2 6.02344 12.6885 6.39583 0.545895 -2.8305 -0.33431 +640 1 16.7919 12.5477 9.81186 8.33998 7.78307 -15.4118 +641 2 16.959 11.947 9.07064 -2.3739 -7.40637 3.16023 +642 2 17.0566 13.4004 9.43565 -5.48117 -2.43007 10.0621 +643 1 6.08508 2.94496 2.79534 5.32525 -4.78467 20.7365 +644 2 6.22401 3.88181 2.60268 1.06349 -0.160394 -8.38338 +645 2 5.80007 2.47136 2.00522 -4.08992 3.93243 -8.80646 +646 1 10.8869 3.24711 3.28239 -4.40001 1.54122 -3.81905 +647 2 10.3919 4.04182 3.50512 -0.182415 -1.04618 4.274 +648 2 10.507 2.97693 2.43998 1.37333 -6.80979 -0.861155 +ITEM: TIMESTEP +40 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.77679 7.00681 17.9176 19.5781 -11.4355 -6.13067 +2 2 7.88289 7.04978 18.2154 -24.3238 4.20085 7.9494 +3 2 8.82569 6.20257 17.3924 1.80136 1.41546 -3.93969 +4 1 18.6608 8.28849 6.81179 -5.26854 6.47195 -37.0065 +5 2 0.259818 8.10211 5.87223 -9.20216 6.37217 14.1473 +6 2 0.533966 7.65898 7.28863 11.4703 -14.4857 21.9358 +7 1 8.44459 18.6539 6.84319 -15.0888 3.44445 3.75329 +8 2 9.31627 0.207433 6.52222 15.1831 4.47029 -4.67038 +9 2 7.87035 0.688968 6.45696 3.7806 -3.44044 1.26969 +10 1 6.57294 1.78151 11.6706 -30.0599 9.45416 18.0529 +11 2 5.79693 2.24632 12.0928 24.7239 -13.8096 -10.3139 +12 2 6.23894 0.879353 11.5248 3.88204 4.12095 -2.29502 +13 1 7.0611 5.68864 2.39703 8.93877 -14.6422 -9.86735 +14 2 6.49127 6.20844 2.93802 -15.3109 10.2002 23.1803 +15 2 6.88849 6.05122 1.53455 1.63853 6.11013 -15.8751 +16 1 16.2018 10.2111 16.0976 42.0151 -2.30245 8.02011 +17 2 17.1767 10.3828 16.1846 -31.1897 -9.90141 -8.38467 +18 2 15.8087 11.0308 16.3852 -12.3763 9.98735 1.02793 +19 1 10.6387 14.9527 2.33657 9.03987 18.5511 -2.17595 +20 2 10.545 14.5243 3.1949 1.96881 -4.62445 -0.461144 +21 2 11.2262 15.72 2.53493 -10.4825 -13.512 -5.5858 +22 1 17.1607 8.25027 10.5569 -10.4361 3.90862 15.3578 +23 2 16.8456 8.92829 11.1924 -0.168965 -8.85021 -9.39988 +24 2 17.9277 8.63713 10.1294 7.74511 3.00226 -1.55375 +25 1 14.7566 15.8542 16.4215 -9.50848 16.8449 -9.38304 +26 2 13.8265 16.1715 16.4278 14.8795 -5.02546 -3.6071 +27 2 14.9162 15.569 17.3232 -2.48975 -11.4773 7.52297 +28 1 12.1331 13.4103 0.48985 -10.556 -4.43922 -13.5861 +29 2 11.9475 13.3795 18.1761 8.0664 -0.863413 7.07636 +30 2 11.3865 13.8946 0.862316 6.65844 3.98247 10.4433 +31 1 9.29843 5.44761 4.00486 3.37284 8.34248 -28.0116 +32 2 8.80378 5.24143 4.78809 -8.97197 -9.15203 12.3932 +33 2 8.61542 5.51114 3.30134 8.62356 -3.76178 8.99247 +34 1 1.79678 4.17189 11.6321 9.86643 -30.5991 16.8051 +35 2 1.62878 5.09135 11.8205 -3.04918 18.6361 6.49963 +36 2 2.25792 3.77365 12.4221 -11.5809 11.2089 -24.12 +37 1 2.02425 6.80455 8.32417 0.209126 8.78432 0.0974623 +38 2 2.41895 7.33028 9.04952 -2.4595 -11.9319 -6.9206 +39 2 1.91003 5.89259 8.64365 4.06316 7.1017 -1.03524 +40 1 5.41039 4.42866 7.97545 15.1976 -3.31539 14.1613 +41 2 5.46063 3.46886 7.81834 -3.32316 3.28084 -1.43066 +42 2 4.8072 4.83488 7.36206 -13.6118 -1.04066 -17.9483 +43 1 3.27942 2.94296 17.507 14.649 -12.38 -13.2068 +44 2 4.01307 3.22765 16.9192 -12.2988 4.29907 8.19647 +45 2 2.92414 3.72569 17.9407 -4.7152 6.06254 1.98711 +46 1 7.44402 5.32718 6.09908 -2.23439 -3.56175 -18.7368 +47 2 8.08992 5.98284 6.3762 -3.15187 6.11466 20.9447 +48 2 6.88688 5.06352 6.84221 3.51936 -1.39652 7.32666 +49 1 9.78623 6.99393 11.9838 -8.59529 -1.09594 -12.3674 +50 2 10.3445 6.45759 11.4052 1.55365 1.23763 7.43723 +51 2 9.00985 7.18223 11.4209 7.62587 2.79809 7.26056 +52 1 14.0725 3.61727 8.08367 12.8617 -8.18347 36.7285 +53 2 14.0228 4.31343 7.45005 -3.4794 19.1063 -13.5046 +54 2 14.4179 4.02628 8.91908 -9.29791 -10.4076 -21.8094 +55 1 4.59231 17.2384 3.97449 0.493238 3.33808 0.649061 +56 2 5.51414 17.4776 4.03994 12.0557 0.622386 5.90157 +57 2 4.23063 17.8039 3.28947 -7.41249 -4.06804 -9.31956 +58 1 16.4721 16.5989 10.1846 -15.657 14.3962 29.6607 +59 2 15.672 16.8273 10.736 23.5631 -12.0212 -18.4682 +60 2 16.1719 15.9965 9.50314 -9.75188 -3.46964 -7.56259 +61 1 1.98052 4.85246 0.373619 -1.44601 4.98585 -7.77412 +62 2 2.7262 5.17853 0.894803 -2.15831 4.7879 6.78517 +63 2 1.59165 5.65237 -0.0264377 4.8265 -6.05414 -1.09652 +64 1 11.6431 13.3034 16.3099 -7.83069 14.4437 11.7005 +65 2 11.0472 12.5464 16.386 4.77345 -10.1552 -4.34879 +66 2 12.2516 13.1635 15.5747 -3.53477 -7.02177 -5.05796 +67 1 10.1531 11.0326 16.9094 -23.9188 11.6521 -2.01913 +68 2 10.5087 10.1543 16.8125 9.70699 -14.9542 1.17008 +69 2 9.18648 10.9213 16.8155 11.1855 0.742098 0.22461 +70 1 11.7413 17.4552 13.4621 -1.23374 28.315 3.5075 +71 2 12.4767 17.2116 12.8888 0.8966 -9.51431 -5.30227 +72 2 11.7922 18.439 13.4864 2.17346 -17.034 -0.823798 +73 1 6.40572 9.32656 12.214 8.55802 19.8904 20.5686 +74 2 6.90308 8.91303 11.5283 8.82473 -10.1612 -21.9185 +75 2 7.05175 9.94906 12.6124 -18.2049 -7.77814 -0.199089 +76 1 16.2334 12.8098 2.68826 14.0272 -12.5996 -1.63763 +77 2 17.097 13.226 2.50419 -12.4159 2.28924 0.929092 +78 2 15.5495 13.4898 2.7216 0.770652 8.50493 2.13384 +79 1 0.665645 12.593 5.91595 32.2246 4.40393 3.59492 +80 2 0.90587 12.5095 4.99041 5.40697 -3.98614 -5.66175 +81 2 18.3758 12.6087 5.91046 -34.4951 5.63016 -3.48792 +82 1 5.23151 16.431 18.4431 -16.7943 8.81872 -4.95242 +83 2 5.79594 15.7593 18.0508 10.3373 -8.32481 3.89376 +84 2 5.47944 16.6222 0.707356 8.36178 -5.19521 1.40492 +85 1 0.571414 7.67431 4.12619 2.94709 1.59491 -2.60127 +86 2 18.6158 8.07004 3.46977 2.09916 -2.88444 -0.00351913 +87 2 1.46322 7.94524 3.84829 -2.55586 0.342718 0.201417 +88 1 3.11705 8.93424 6.4998 54.1901 -7.8337 2.25484 +89 2 3.7667 8.5317 7.12157 -13.167 10.549 -15.4875 +90 2 2.28764 8.76575 6.88741 -36.769 -1.96533 12.6863 +91 1 7.28047 10.3297 16.2671 12.2744 -1.5589 -10.8048 +92 2 6.65751 10.5384 15.5688 -5.93087 0.719661 3.96859 +93 2 6.78418 10.1979 17.0822 -4.65586 3.14184 2.44827 +94 1 11.1311 1.01006 5.00872 -4.59838 3.25637 13.1063 +95 2 11.104 1.87564 4.56859 3.00456 -5.57579 -4.19999 +96 2 10.7195 0.375584 4.41788 -1.87117 -0.379426 -13.1931 +97 1 4.37947 2.77237 13.219 1.2209 -0.528365 -1.66794 +98 2 4.72737 3.08878 14.0495 2.85744 14.0767 5.60955 +99 2 4.20383 1.85536 13.4394 -3.83295 -12.6961 -6.71285 +100 1 8.38383 10.1509 1.80871 -12.6182 20.2791 -9.41543 +101 2 8.178 10.838 2.47049 7.2019 -6.44506 -5.42193 +102 2 8.73482 9.42727 2.30684 9.9898 -17.6863 11.9989 +103 1 10.4319 1.72481 15.5562 12.4011 -4.85254 7.43664 +104 2 11.3895 1.56158 15.4091 -17.4954 3.73262 -0.131687 +105 2 10.062 2.13812 14.7716 6.37582 -0.463351 -11.2945 +106 1 2.70803 12.8564 7.7877 0.947466 12.6679 0.63847 +107 2 3.18684 13.6562 7.51328 0.350127 -6.04869 0.642024 +108 2 1.99719 12.778 7.13709 0.576803 -6.26493 0.417134 +109 1 3.70343 11.6943 5.19413 20.2082 20.004 0.0632986 +110 2 3.58824 10.8286 5.55511 -6.2763 -16.1433 9.0068 +111 2 3.08304 11.8089 4.48497 -14.3756 -1.22762 -7.56914 +112 1 6.79775 14.44 16.9261 12.4025 3.68508 -3.36544 +113 2 7.76361 14.3574 16.912 -9.58328 3.53086 0.838276 +114 2 6.54478 14.7426 16.0399 -3.94857 -4.38541 1.40645 +115 1 14.2011 14.5459 3.3522 -3.08566 -2.84615 -1.00806 +116 2 13.6596 15.3308 3.14384 3.83224 -9.07839 4.89455 +117 2 13.7292 13.9763 3.99269 1.14293 11.3016 -6.48612 +118 1 8.39096 18.1361 16.0337 -32.316 13.1552 1.22555 +119 2 8.83502 17.3455 16.3332 22.4875 -6.85104 -0.859562 +120 2 8.9267 0.219511 15.6905 18.196 -4.39201 7.01778 +121 1 4.72714 1.63535 4.92703 -26.6842 -20.3158 26.1173 +122 2 3.8064 1.92851 4.99525 4.72714 3.40068 -1.69015 +123 2 5.07003 2.08002 4.18139 17.9323 21.4409 -28.6349 +124 1 14.9964 12.7123 16.4352 -4.22015 -14.1687 -30.4934 +125 2 14.5029 13.21 17.0522 -6.30453 18.4993 32.9687 +126 2 14.3164 12.5754 15.7407 23.1427 -3.84454 1.0347 +127 1 15.7385 18.4508 16.8675 -13.9243 -22.2803 -23.7862 +128 2 16.4074 18.4637 17.529 20.9098 4.79862 21.1737 +129 2 15.5806 17.4953 16.7298 -7.09236 11.271 1.12369 +130 1 1.21817 1.19055 16.5653 11.7565 -7.97186 -17.2906 +131 2 1.96844 1.77109 16.7379 1.96571 4.11248 6.40071 +132 2 0.658106 1.26508 17.3256 -9.62795 7.29392 16.1709 +133 1 18.134 4.50826 15.9251 -3.15057 6.2034 16.9599 +134 2 18.3539 4.06683 15.1192 3.29697 -9.24478 -15.9855 +135 2 0.215105 4.3469 16.5346 0.451532 1.5183 -0.00159427 +136 1 12.2559 16.9635 16.13 9.81693 16.417 -30.969 +137 2 11.5335 16.7255 16.6761 -27.6315 -15.1383 17.2649 +138 2 11.8852 17.008 15.2138 11.4543 -2.176 15.2032 +139 1 16.0072 2.53826 18.0715 2.86853 -7.51147 -8.26075 +140 2 15.4847 3.23875 18.4474 -1.55266 16.6686 8.62869 +141 2 15.8031 2.59593 17.1292 0.710765 -2.58084 -2.04371 +142 1 6.70782 13.8427 10.2201 -0.679857 -3.70625 -19.7607 +143 2 6.50134 13.5235 11.1067 -0.321862 -5.5215 0.0793921 +144 2 6.59662 13.1168 9.5703 -2.40279 4.60459 14.5526 +145 1 10.136 18.3381 2.74267 -18.0567 -22.0341 20.6824 +146 2 10.1719 0.451126 2.17508 1.85432 15.9621 -15.8725 +147 2 9.21984 17.9907 2.65838 20.6262 7.0183 -5.07627 +148 1 3.02443 17.7208 6.1026 17.1013 10.0229 -4.66436 +149 2 2.15568 17.711 5.71196 -13.0363 -3.14036 -7.80794 +150 2 3.59824 17.9918 5.35649 -4.18715 -9.59785 14.6662 +151 1 12.576 16.8948 8.01086 19.6337 5.92584 -6.52436 +152 2 11.8143 16.3513 7.79321 -8.3204 -4.9503 8.18666 +153 2 12.4158 17.4227 8.81259 -8.93553 -1.00079 -7.85288 +154 1 14.8883 15.2954 8.22088 18.3997 -23.9506 8.44323 +155 2 14.185 15.9366 8.136 -10.7922 9.32905 -8.87486 +156 2 15.3949 15.2296 7.38647 -11.857 13.9652 6.76292 +157 1 17.682 18.2494 0.348905 -7.91474 13.422 2.87656 +158 2 18.5411 17.7865 0.321045 -1.05993 10.3639 -2.93184 +159 2 17.7527 0.554981 0.612143 9.7328 -21.6142 -4.56589 +160 1 0.864553 10.4271 1.36107 38.8853 37.5027 -14.379 +161 2 0.108953 9.99831 1.68821 -41.9718 -23.1906 9.82059 +162 2 0.582253 11.2112 0.83245 0.481516 -18.0373 9.72219 +163 1 1.69239 12.2275 3.35367 -4.8948 -13.153 3.57872 +164 2 1.37753 11.4769 2.79371 7.82838 19.3971 -0.83705 +165 2 1.72119 13.0511 2.84994 -1.71551 -5.72989 -9.02345 +166 1 0.593488 17.2339 4.88925 5.54216 -9.27995 13.1842 +167 2 18.6577 17.9974 4.73698 -0.720643 -6.26101 15.0882 +168 2 0.46443 16.7935 5.76992 -5.72363 16.5902 -22.8723 +169 1 1.11371 0.949119 9.43078 -14.7072 -12.8067 -15.4602 +170 2 1.29442 0.455313 10.245 -0.545661 8.99323 2.98013 +171 2 0.250893 0.599212 9.12975 16.3522 9.05079 5.79158 +172 1 16.7438 2.34594 13.2927 -5.57812 -16.9062 26.8121 +173 2 16.8801 2.6271 12.4058 4.66444 4.54161 -27.0891 +174 2 16.4868 1.39796 13.2842 6.06262 14.3342 0.102967 +175 1 2.62374 15.8311 12.1325 -18.0747 14.04 -25.4855 +176 2 3.15014 15.3809 12.7666 13.9506 -11.3972 18.0386 +177 2 3.07511 15.7224 11.2774 1.07994 -2.68321 4.96368 +178 1 16.4243 15.6576 6.03755 15.9104 -4.34147 -2.36376 +179 2 17.3476 15.7161 6.33483 -8.235 -6.85341 4.18965 +180 2 16.3427 16.413 5.44101 -7.92512 0.157724 -1.18513 +181 1 5.79129 5.09168 11.8004 -4.72983 -0.0241771 3.34223 +182 2 5.24592 5.67928 12.3598 8.87085 -1.40185 -4.45321 +183 2 5.33436 4.24005 11.794 -1.89173 5.24027 0.81451 +184 1 15.1611 4.86757 0.757741 -10.8083 7.02962 -6.60621 +185 2 15.185 4.56786 1.66832 -2.59424 -2.50065 9.27943 +186 2 14.3347 5.37902 0.687967 11.9305 -6.73266 -3.44958 +187 1 16.3215 16.3801 2.08305 3.66808 -22.0917 28.3334 +188 2 16.2883 16.7145 3.0131 -8.2177 -1.24054 -23.9705 +189 2 16.5228 17.1161 1.52724 6.03518 21.1991 -10.8898 +190 1 0.258418 4.84833 3.80491 9.83943 -33.1452 17.0376 +191 2 0.435143 5.7654 3.92096 2.60191 31.4745 -0.643169 +192 2 0.932226 4.39489 4.35318 -12.3014 6.6918 -13.6862 +193 1 2.96829 15.0617 15.1396 -6.44278 -4.84309 -5.22724 +194 2 2.79942 14.7982 16.0602 -0.108783 -2.99279 -5.19286 +195 2 2.41643 15.8476 15.0194 7.7594 2.37019 3.88633 +196 1 1.13965 14.6405 9.53256 -35.9747 -40.3241 22.6064 +197 2 2.06314 14.7027 9.49112 43.1319 12.9068 -8.07313 +198 2 1.0594 13.7772 10.0119 -9.44904 20.5678 -15.2205 +199 1 13.5675 16.5961 11.5382 5.93785 -23.7105 -2.52771 +200 2 13.3768 17.2545 10.8786 -7.41053 16.3631 -3.48345 +201 2 13.1856 15.7884 11.1314 1.00946 8.65797 10.7521 +202 1 4.66618 1.4643 0.77663 11.7421 5.19522 -12.5382 +203 2 4.19094 2.00712 0.127209 -4.75679 -3.07286 5.52347 +204 2 4.08138 0.751582 1.04859 -6.60629 -1.36494 5.43578 +205 1 1.44472 18.5589 11.8552 5.89014 -29.5111 2.70443 +206 2 1.28184 0.411827 12.6654 0.0657759 4.1157 4.72514 +207 2 1.66959 17.6355 12.1243 -0.811151 21.0135 -2.36357 +208 1 11.5239 10.1243 4.0099 -6.2394 6.26334 5.03821 +209 2 11.225 10.535 3.18075 6.07738 -4.97061 3.39644 +210 2 12.4891 10.1836 4.01184 1.61922 -2.52467 0.807021 +211 1 8.27885 12.1614 3.71144 8.13123 -6.41358 -26.5436 +212 2 9.10665 12.5897 3.97429 -2.42085 2.52867 6.94663 +213 2 7.68553 12.1691 4.45091 -10.6399 7.25218 24.1014 +214 1 14.4389 4.03262 3.28382 -1.54769 2.04788 0.687462 +215 2 14.9998 3.98927 4.07922 -0.140352 3.9435 -3.93632 +216 2 13.6855 4.60992 3.49399 3.24138 -5.01437 4.30138 +217 1 5.6049 1.66195 7.51556 2.43321 19.3851 -35.7094 +218 2 4.99817 1.05358 7.93111 -11.2062 -8.09843 6.71806 +219 2 5.29033 1.73413 6.56196 15.7086 -7.98236 30.9511 +220 1 17.8679 1.11465 4.8662 -8.84521 -11.3875 -0.414623 +221 2 18.5938 1.34898 4.28573 7.92092 9.45731 -1.66923 +222 2 17.9348 1.63294 5.67672 2.41874 4.31495 -1.38437 +223 1 6.82183 9.41821 4.49596 0.331068 -0.81956 4.69879 +224 2 6.92763 9.68813 5.42975 0.55668 -5.9518 -10.6641 +225 2 7.69076 9.13696 4.17138 2.49623 1.53594 7.84385 +226 1 2.6692 14.9191 1.96889 -13.7427 -15.0981 33.3863 +227 2 3.22272 14.7135 2.75628 -3.53882 5.4164 -17.9931 +228 2 3.23582 15.271 1.30455 16.0902 7.51076 -16.3339 +229 1 17.3236 12.914 13.1856 6.20451 10.459 -3.7314 +230 2 16.5162 13.3803 13.3896 -16.2035 -4.78456 4.03007 +231 2 17.8657 13.6659 12.9192 5.22743 -7.26423 -1.93052 +232 1 14.957 10.5619 1.40158 33.4378 15.8576 14.4167 +233 2 15.5687 11.2535 1.77718 -16.3935 -17.8486 -10.6273 +234 2 14.0947 10.9454 1.47451 -15.7071 3.57407 -1.68856 +235 1 5.70225 6.80052 4.56184 6.57688 14.9147 -7.26545 +236 2 6.13296 7.68472 4.64206 -12.0226 -12.483 -2.28626 +237 2 6.28869 6.17268 5.00191 2.5554 2.13057 5.94298 +238 1 8.01258 8.29623 10.2593 -8.54796 -9.21297 9.02749 +239 2 8.56841 9.06789 10.0886 3.62647 -1.62136 -15.6888 +240 2 7.62542 7.94814 9.4343 7.03713 6.69092 4.95874 +241 1 13.441 18.4149 5.75957 4.19405 2.302 -13.2138 +242 2 12.6243 0.255994 5.52243 8.89948 -2.22339 5.88848 +243 2 13.1991 17.7887 6.44621 -5.69407 0.108635 9.70575 +244 1 0.157493 2.61527 0.174457 -9.01339 -22.8294 -0.321401 +245 2 17.938 2.88173 18.4446 6.58659 5.28303 7.29983 +246 2 0.732894 3.35773 0.380844 -2.17088 12.8237 -3.11298 +247 1 12.7457 11.0391 9.7485 36.4778 -29.6492 25.4167 +248 2 11.881 10.9734 9.40839 -39.1103 -1.43989 -11.0388 +249 2 12.9187 10.1217 10.0968 -0.290925 20.2268 -9.99681 +250 1 0.740308 12.1745 11.0603 -22.9837 8.27774 -1.01284 +251 2 18.4139 12.2368 11.1424 7.83285 -3.43363 -6.48653 +252 2 1.04445 12.5328 11.8929 13.1768 -0.7817 9.81141 +253 1 5.09631 7.29496 13.4329 -5.02176 -6.40528 2.12919 +254 2 5.65923 7.87015 12.9013 0.281799 7.42737 5.37855 +255 2 5.54275 7.21467 14.2893 3.22018 -2.41867 -5.38403 +256 1 1.21307 6.88521 11.8471 45.2055 23.2855 19.4361 +257 2 0.504281 7.33909 11.418 -17.6401 7.5893 -9.966 +258 2 1.85566 7.62216 12.1147 -28.9146 -29.9066 -6.84092 +259 1 15.4951 9.58282 12.318 3.7565 -9.08444 -2.54037 +260 2 14.9885 10.3731 12.1762 -1.60608 19.4691 -5.65324 +261 2 15.197 9.26603 13.1641 1.66558 -4.92983 10.8479 +262 1 16.5876 12.7654 5.4778 8.29992 -4.99789 29.9812 +263 2 16.3841 13.7077 5.58453 -1.61151 1.51391 -8.42869 +264 2 16.4534 12.5134 4.57091 -6.79319 5.2662 -20.9737 +265 1 6.24519 9.93185 0.0511849 19.8307 -8.34124 26.5163 +266 2 5.62326 10.391 0.623031 -8.96333 4.37615 -1.09153 +267 2 7.04636 9.86115 0.632167 -14.2701 4.68407 -14.2447 +268 1 12.3094 6.10151 4.07154 29.4526 9.60181 -18.9544 +269 2 12.3581 6.67925 3.27122 -7.72489 -2.14158 19.4346 +270 2 11.4533 5.70734 4.07903 -24.5921 -5.49884 -2.8127 +271 1 0.238725 12.7856 0.183979 8.51406 3.08383 0.253195 +272 2 0.144933 13.4932 0.833619 -6.86037 1.22763 2.8825 +273 2 18.4214 13.096 18.0418 -3.66036 2.31192 -5.9902 +274 1 3.70956 18.598 8.57987 -8.91795 8.796 11.4474 +275 2 3.55449 18.0356 7.80833 -3.96611 6.10323 -0.149317 +276 2 2.8446 0.378518 8.78385 11.2365 -8.2841 -4.38951 +277 1 7.48876 17.3305 4.49636 -9.17434 -25.7083 -0.449464 +278 2 7.67261 18.2518 4.49855 7.01126 32.4538 5.60223 +279 2 7.56532 17.0943 3.57389 -1.71949 -1.63571 -7.00131 +280 1 9.24209 17.1007 12.2607 -0.0867103 -4.31389 -13.5747 +281 2 9.30622 16.4126 11.5797 -4.40084 -0.983353 3.37399 +282 2 10.1228 17.1279 12.6444 4.44927 1.46684 7.86514 +283 1 13.3362 12.9421 7.98122 6.55916 41.1429 -16.6734 +284 2 13.3796 12.1892 8.55526 4.57885 -11.5398 14.8452 +285 2 13.9495 13.647 8.31623 -8.21726 -16.9651 -6.13203 +286 1 14.9343 2.98184 15.3399 -18.8859 -3.08059 15.3623 +287 2 14.3306 2.22694 15.2091 8.05839 6.56319 -1.64083 +288 2 15.5611 2.99492 14.6188 6.00199 -3.60128 -9.94013 +289 1 9.8611 15.5568 16.9864 -5.18568 1.15062 7.50023 +290 2 10.3014 14.7282 16.7357 2.8278 3.85059 0.776615 +291 2 9.42894 15.4199 17.8518 3.24739 -0.30663 -9.25648 +292 1 11.3089 8.34774 16.5637 -8.99518 -4.25182 3.40254 +293 2 10.6351 7.93491 15.9913 5.93093 -1.15278 9.90769 +294 2 11.3777 7.78039 17.3602 -0.876032 6.75541 -11.8921 +295 1 3.86263 18.1743 16.7605 8.31608 -24.0238 3.67333 +296 2 4.34809 17.526 17.3016 -5.03788 -1.4921 -11.4176 +297 2 3.91859 0.291346 17.3034 -3.84782 28.4328 8.21839 +298 1 2.18675 4.1526 8.92206 -24.1698 7.19476 -17.4672 +299 2 3.08777 4.02084 8.66345 19.2563 -3.88604 2.84364 +300 2 2.11989 4.14607 9.87269 6.11123 -7.11558 17.6044 +301 1 9.878 10.3743 9.69372 5.53967 -18.4491 14.0185 +302 2 9.43572 11.1423 9.3425 -1.35277 14.796 -0.820696 +303 2 10.0526 10.4842 10.6451 0.294207 2.81912 -6.3598 +304 1 9.67606 0.861397 10.8616 12.1631 -0.119776 7.34561 +305 2 9.24662 0.0503119 11.2005 -2.60905 7.79605 -9.27605 +306 2 9.17358 1.27941 10.1433 -7.66403 -7.87567 2.43043 +307 1 9.19351 15.1133 10.2188 11.11 2.94282 0.236533 +308 2 8.72034 15.7288 9.64731 -2.95318 7.0206 -0.021652 +309 2 8.61234 14.3559 10.3013 -9.273 -0.749783 0.810803 +310 1 0.983709 9.49699 10.2982 -74.1988 19.4185 4.2569 +311 2 0.893433 10.4494 10.5162 13.7438 -13.7231 -2.84852 +312 2 1.86549 9.26486 10.2468 58.3196 -6.52918 -3.90093 +313 1 16.9084 4.83943 8.1598 4.06942 21.6595 -28.8412 +314 2 16.3724 5.61591 8.36865 -1.41178 -4.09344 3.51719 +315 2 16.8393 4.26054 8.89216 -0.699807 -17.3102 23.1105 +316 1 14.7125 14.7098 0.257213 21.3866 7.73012 -2.74727 +317 2 15.2455 15.0698 0.987096 -5.24332 1.02996 -2.3964 +318 2 13.934 14.3364 0.654485 -15.8904 -6.61515 6.72623 +319 1 3.61962 11.0361 9.55343 7.54802 -1.42323 12.4812 +320 2 3.62776 11.3571 10.4773 -0.544226 1.54555 -6.56144 +321 2 3.18313 11.7186 9.01674 -3.18494 -0.813089 -1.4949 +322 1 11.1481 10.7794 1.3867 -18.0125 -13.9714 2.13506 +323 2 11.5419 11.6189 1.17487 5.50703 16.2749 -10.1623 +324 2 10.2377 10.7815 1.02242 13.9743 0.382042 6.15217 +325 1 13.1644 7.14571 12.7934 28.1674 11.2254 -0.0108115 +326 2 14.1505 7.05998 12.7803 -16.3048 -3.53009 2.57838 +327 2 12.835 6.25234 12.9024 -6.40061 -9.363 -1.95696 +328 1 9.62034 1.87073 0.979069 -6.9897 -0.645983 -14.1021 +329 2 8.86926 1.41829 0.528843 9.90899 13.9476 5.87182 +330 2 10.1257 2.37739 0.312436 -3.40486 -11.198 4.68953 +331 1 10.6367 13.5403 4.62088 -14.2461 -11.7796 -9.34504 +332 2 11.3649 12.9086 4.64313 9.4379 4.41524 3.81629 +333 2 10.614 13.9519 5.48444 4.98914 7.07 10.6976 +334 1 14.3951 1.77229 10.9373 11.882 -13.8992 0.14286 +335 2 15.2529 1.46692 10.5904 -8.80209 -5.09491 0.192719 +336 2 14.4998 2.72321 10.9422 -3.89457 8.74507 -1.42899 +337 1 14.6035 12.2778 11.6732 8.28457 -2.47972 34.5189 +338 2 15.3822 12.4706 11.1386 -1.8445 -1.29245 -12.2333 +339 2 13.8238 12.1274 11.1597 -9.6117 -2.29221 -24.4043 +340 1 8.21682 5.05944 9.82725 33.2235 -12.7421 -22.1109 +341 2 7.50249 5.31613 10.3805 -26.8995 -2.6371 14.604 +342 2 8.16278 4.09579 9.61432 -6.39419 19.305 4.57693 +343 1 1.57178 16.8746 18.3696 -12.5949 -28.7752 19.8992 +344 2 1.95856 17.2997 17.6256 12.4489 12.7929 -23.944 +345 2 1.61191 15.9133 18.1414 3.74732 18.7705 7.54273 +346 1 1.50483 17.2622 15.3369 -31.2805 -0.211241 0.372367 +347 2 1.56428 18.1715 15.7008 -8.02099 -13.4799 -3.86937 +348 2 0.550545 16.944 15.3287 29.8388 16.9503 2.40621 +349 1 3.67189 5.70682 6.10259 2.52977 5.35962 -6.45813 +350 2 3.10512 6.24939 6.65687 -5.8484 1.84291 7.09291 +351 2 4.11645 6.33532 5.504 1.86189 -8.61654 4.18176 +352 1 12.4205 9.46682 14.1922 0.00765934 6.29699 5.01976 +353 2 12.7713 8.66673 13.7826 1.27338 -5.49384 -0.333278 +354 2 12.2037 9.20626 15.0998 2.51081 -2.42178 -0.168732 +355 1 4.04257 15.2822 6.8914 -27.6779 4.92775 8.06061 +356 2 3.56316 16.0906 6.63798 2.42102 -8.57509 -1.16647 +357 2 4.95231 15.5118 6.77617 25.3206 1.78005 -4.31003 +358 1 0.630616 8.59357 14.9621 0.0534875 13.3347 6.63524 +359 2 0.475879 9.54739 15.0951 0.802494 -5.58418 -0.636111 +360 2 1.32488 8.5708 14.2996 4.58301 -1.27906 -6.75903 +361 1 12.9988 8.28033 10.3217 -21.3611 19.4324 1.5895 +362 2 13.6573 7.74741 9.88515 12.8548 -10.016 -2.83384 +363 2 12.9714 7.9897 11.246 0.968107 -4.04745 -5.09921 +364 1 15.3184 7.7322 3.54707 4.18654 -9.90345 10.9868 +365 2 14.6375 7.17364 3.22195 -21.9236 0.488691 -25.4272 +366 2 15.542 7.2045 4.31452 16.9904 15.0521 14.7627 +367 1 17.298 6.68564 0.0426033 13.9193 -14.0885 -0.920406 +368 2 16.8642 5.82471 0.139777 0.0396094 5.05794 2.76644 +369 2 16.6003 7.28204 18.4358 -17.9105 11.3609 -4.38582 +370 1 8.85442 6.93876 7.83202 25.5204 20.9839 -12.9835 +371 2 9.78415 7.28149 7.87459 -21.3181 -5.86923 -3.23496 +372 2 8.81067 6.25344 8.49096 -5.61401 -13.4392 14.4413 +373 1 12.3763 0.596552 1.22002 -1.17453 2.99561 6.82033 +374 2 13.3385 0.528874 1.30915 -5.26207 -0.953155 0.827968 +375 2 12.0852 0.273415 0.369127 5.54968 -2.26078 -4.64309 +376 1 5.63283 15.1348 14.5573 -11.4131 -7.08845 -3.56826 +377 2 4.66833 15.2302 14.6984 9.61439 -4.03287 3.27369 +378 2 5.92452 15.9751 14.1944 7.77409 8.39082 -1.96781 +379 1 3.86657 6.44559 1.75085 5.80409 -14.6499 1.98717 +380 2 3.55249 7.31671 1.4889 -5.45171 9.45984 0.647045 +381 2 4.14269 6.4981 2.68117 -5.39897 6.08822 -6.8935 +382 1 3.91507 11.6157 12.3486 -13.4135 -1.42429 5.74998 +383 2 4.7693 12.0145 12.538 6.44699 -0.479912 -1.2837 +384 2 3.27735 12.1325 12.8813 7.77399 -7.15276 -11.5357 +385 1 5.36262 3.86651 15.8768 12.1389 -59.3419 -3.52329 +386 2 6.1064 3.19888 15.7551 -26.8485 22.8054 1.66706 +387 2 5.75212 4.71249 15.8089 15.627 34.646 -1.2618 +388 1 14.3819 10.2457 4.44716 -17.5064 5.46907 41.0935 +389 2 14.5449 9.71992 5.26671 -1.94493 10.8322 -14.5796 +390 2 14.8723 9.82528 3.76702 14.2142 -16.5996 -23.0963 +391 1 7.82031 17.402 9.18196 15.4978 -20.6961 5.52716 +392 2 6.95708 17.6159 9.5372 -6.73409 6.75657 -1.79958 +393 2 8.0438 17.9374 8.41052 -8.48575 5.6988 -1.01071 +394 1 4.52697 14.5011 3.99561 -1.64824 1.80571 -15.4173 +395 2 4.43911 15.4257 4.28139 2.0309 -4.99506 3.13673 +396 2 4.3827 13.9072 4.73582 -0.0495062 -0.930109 11.2178 +397 1 14.2192 7.41869 15.785 -17.5888 -3.59777 -10.979 +398 2 15.1626 7.35697 15.6947 20.631 -1.7403 -3.62609 +399 2 14.073 7.80524 16.6426 0.667235 5.42077 11.7037 +400 1 2.9565 18.2605 1.91108 1.19197 -18.909 -26.3864 +401 2 2.43337 17.7432 1.2423 11.354 8.34367 16.4878 +402 2 2.37308 0.276014 2.2689 -15.3488 13.3111 9.03739 +403 1 8.00359 1.60253 4.55907 -38.5212 -7.91491 7.83452 +404 2 7.38229 2.10405 3.99193 12.1921 -3.74558 1.60605 +405 2 8.88232 1.74243 4.26439 24.0023 10.0694 -13.3902 +406 1 2.4736 14.1336 17.6839 19.5549 7.85258 6.07398 +407 2 1.90347 13.5339 18.1719 -6.00167 -6.95039 -0.586477 +408 2 3.38553 13.9045 17.9683 -9.72011 -2.72883 -0.373401 +409 1 0.820064 1.73894 13.8888 -18.5285 5.33114 2.4032 +410 2 0.803771 1.49328 14.8397 -2.66487 6.43341 -16.8821 +411 2 18.5531 2.02517 13.6233 21.0072 -9.49287 13.5993 +412 1 4.44957 0.0409644 13.9204 -25.6038 8.03756 8.31677 +413 2 5.34611 18.3721 13.8825 17.1601 -8.5878 1.82821 +414 2 4.09536 18.4705 14.8092 8.9848 -0.155186 -10.4675 +415 1 7.11939 0.665063 18.3496 37.4596 -16.3367 -22.9959 +416 2 7.39046 0.248229 17.4868 -7.59422 10.3961 22.0522 +417 2 6.17976 0.73857 18.3349 -24.6121 7.91301 3.99406 +418 1 16.0679 18.4255 14.0033 46.948 4.07246 14.5496 +419 2 15.1925 18.2569 13.7481 -41.7006 -8.82757 -2.39817 +420 2 16.1514 18.46 14.9783 -11.5795 5.15321 -10.1321 +421 1 10.0899 4.51466 16.2755 46.1692 31.6348 -9.79269 +422 2 11.0262 4.80528 16.0633 -26.3332 -3.27592 13.4521 +423 2 10.217 3.58436 16.3451 -11.2214 -29.3564 0.661634 +424 1 15.916 17.7977 4.41903 32.6965 1.49817 -6.30174 +425 2 16.457 -0.0326327 4.45612 -4.70593 -7.03645 1.74937 +426 2 15.0663 18.0576 4.73092 -30.5769 8.16516 8.13282 +427 1 7.01211 17.4116 13.808 -11.1093 -0.0306798 -7.53718 +428 2 7.48321 17.731 14.5797 1.71822 -1.35338 6.01299 +429 2 7.70771 17.2257 13.1599 -0.832239 2.47859 1.40448 +430 1 13.2731 6.49483 6.63036 5.49864 12.0855 21.8831 +431 2 14.0036 7.1367 6.53142 -6.95912 -13.4785 -6.50558 +432 2 12.9191 6.26998 5.7719 1.78547 5.07661 -13.1828 +433 1 7.78873 2.35817 9.26787 13.6578 7.92928 32.9359 +434 2 7.26595 2.28464 10.098 4.41261 -4.66671 -14.4408 +435 2 7.24114 2.08424 8.54668 -18.4281 -7.28868 -15.4379 +436 1 15.1807 14.8213 13.6836 12.0158 -14.5979 1.51453 +437 2 15.023 15.1631 14.5679 -5.44227 3.64048 5.06686 +438 2 14.7818 15.3898 13.0312 -8.03448 9.52233 -3.65179 +439 1 9.37687 8.31604 3.76928 5.34304 4.19186 5.02399 +440 2 10.2244 8.59911 4.15846 -6.46746 6.21109 -7.45595 +441 2 9.38739 7.36131 3.86692 -0.369722 -6.10407 -0.56198 +442 1 17.7826 13.5587 16.3931 -18.259 -13.3606 7.93732 +443 2 16.8564 13.2543 16.3515 3.23179 3.05811 2.18424 +444 2 17.7493 14.412 15.956 6.45918 8.6709 -4.68033 +445 1 4.96945 10.6182 2.7671 -20.0352 21.3698 -14.9929 +446 2 5.67156 10.2863 3.30832 14.7689 -7.42384 15.9186 +447 2 4.73305 11.5 3.12196 4.54065 -18.1741 -2.81522 +448 1 3.75186 8.34553 10.1595 -2.54049 11.5371 -18.7835 +449 2 3.83158 9.28658 9.87851 -1.62744 -10.9109 6.60301 +450 2 3.69687 8.33176 11.111 2.12623 4.07512 13.0596 +451 1 16.0105 7.02075 6.14683 -8.93467 17.9282 -2.69417 +452 2 16.8191 7.42843 6.45697 9.04966 6.41713 2.22097 +453 2 16.1641 6.09023 6.1704 3.21598 -21.4167 -2.94797 +454 1 15.1148 7.07457 9.06702 4.51295 -11.3361 21.5265 +455 2 15.7278 7.43111 9.72685 3.64545 -0.886375 -6.04752 +456 2 15.1684 7.6713 8.33808 0.281889 14.352 -20.2518 +457 1 6.32562 13.0044 12.7823 3.64263 -12.4915 -10.2251 +458 2 7.18031 12.5985 13.0233 -9.44077 2.88231 5.28619 +459 2 6.10277 13.6925 13.4113 4.07235 10.5841 12.4872 +460 1 12.13 4.50388 13.0978 -23.9143 -18.2098 -29.5576 +461 2 12.2018 4.66005 14.0386 -4.52664 -3.61945 12.4396 +462 2 11.31 3.95423 12.8708 29.5104 21.9629 17.7949 +463 1 11.3628 8.1671 7.89263 -5.63688 4.26156 -3.21905 +464 2 12.0486 7.63378 7.48497 5.26632 -9.68169 -9.18733 +465 2 11.6596 8.25059 8.79652 3.08614 3.11673 13.4283 +466 1 17.1728 10.8467 7.48683 -9.78257 9.61375 -3.53187 +467 2 17.8082 10.1926 7.21604 13.2987 -16.4259 3.23364 +468 2 17.1151 11.4269 6.71399 -11.2446 1.98681 4.69156 +469 1 5.26156 18.1118 11.0164 11.279 0.780011 3.76881 +470 2 4.63029 17.9037 11.706 -3.79608 -1.61163 6.00067 +471 2 4.75114 18.4846 10.3039 -10.5863 -2.03901 -14.6626 +472 1 7.60927 17.5116 1.80376 -12.2084 0.332405 -16.0787 +473 2 7.73547 16.6894 1.27511 4.49641 20.7738 7.60921 +474 2 7.29137 18.2078 1.17993 10.7818 -15.1152 7.96202 +475 1 1.93242 12.9038 13.5907 -11.1009 -8.62515 -2.91716 +476 2 1.44204 12.3193 14.1878 -0.742257 0.132846 -0.79095 +477 2 2.14259 13.6778 14.1103 6.96653 11.7909 8.84583 +478 1 9.6349 6.79099 14.8483 -7.90933 -4.5792 7.57822 +479 2 9.76837 5.84646 15.0736 0.917781 12.494 -4.6794 +480 2 9.97866 6.97841 13.9703 0.736717 -7.57275 -8.26148 +481 1 15.2733 4.3257 10.7584 -18.0594 -0.89979 -6.45033 +482 2 16.1458 3.96681 10.9687 3.533 12.3702 4.36819 +483 2 14.9475 4.94569 11.4317 15.7147 -3.56113 0.605423 +484 1 11.2438 6.16931 0.179082 0.0277951 -2.16566 -3.90965 +485 2 11.3357 5.30361 18.4317 14.8036 -12.0621 -1.88578 +486 2 10.2956 6.2638 0.1816 -11.5861 14.503 2.02073 +487 1 0.0439986 11.3816 15.0585 -6.49496 4.09431 2.20477 +488 2 18.034 11.5578 14.353 7.75523 3.54925 4.26198 +489 2 -0.111373 12.1024 15.7029 3.25408 -7.01329 -10.5532 +490 1 7.06114 9.23722 7.26386 23.5376 12.3273 -0.106793 +491 2 6.50127 8.56776 7.63843 -10.2441 -19.5548 5.03643 +492 2 7.97426 8.90952 7.38371 -13.166 2.65106 -3.29749 +493 1 18.3483 15.3728 12.3401 -6.10947 1.64082 -0.490965 +494 2 0.640544 15.4003 12.1341 13.3619 2.30286 0.418231 +495 2 17.9315 15.8707 11.6253 -4.70162 -1.66258 -3.35097 +496 1 16.5284 4.37134 5.23872 23.865 15.8443 -24.0922 +497 2 16.795 4.23475 6.13242 -1.17196 -10.8972 27.7735 +498 2 17.3848 4.63349 4.80865 -25.3878 -11.1359 -1.24016 +499 1 17.7266 3.13043 10.7284 -15.1505 -16.4799 -4.03799 +500 2 -0.0205156 3.31599 11.0266 10.8372 -1.61224 -0.261482 +501 2 17.686 2.21262 10.3629 5.98361 15.5222 5.29053 +502 1 12.2768 0.00077952 10.1229 -5.39949 -11.0736 -0.564535 +503 2 11.3994 0.337416 10.3512 -3.44242 -0.519791 1.58275 +504 2 12.8621 0.740723 10.2534 12.1364 13.942 1.61795 +505 1 10.3933 9.78571 12.4371 -17.696 -6.66554 -9.33286 +506 2 11.04 9.8019 13.1479 9.02187 0.111511 2.28178 +507 2 10.1583 8.84624 12.3274 6.95171 5.58218 -0.582165 +508 1 0.583846 2.83323 7.01904 8.81732 -31.8654 7.83245 +509 2 0.599611 3.49885 7.68934 -3.58556 22.6003 9.07619 +510 2 0.952398 2.07883 7.51841 -6.10214 6.37924 -11.0018 +511 1 0.367433 15.2949 6.92522 -4.7012 3.61818 34.4112 +512 2 0.558547 14.7156 7.70153 -1.71176 22.246 -5.06421 +513 2 0.60814 14.7658 6.19753 10.4713 -26.0103 -27.8181 +514 1 17.0409 7.00624 15.2099 -22.5014 1.92016 -1.24665 +515 2 17.7387 7.65639 15.0691 10.2085 -5.07189 3.59706 +516 2 17.3996 6.21947 15.6455 8.09739 1.82665 -3.45815 +517 1 9.08645 12.4582 8.07298 60.2845 4.68897 0.226728 +518 2 9.45122 11.8173 7.41895 -17.2892 5.38378 7.41181 +519 2 8.16079 12.445 8.11596 -46.4448 -7.25102 -10.4423 +520 1 1.26434 1.84534 2.97351 6.14985 -4.32801 10.6126 +521 2 0.602074 2.03133 2.30849 -1.31532 11.5451 -8.74279 +522 2 1.61884 2.681 3.33622 -3.80121 -10.2767 -5.51985 +523 1 4.10472 15.1163 9.79145 -1.9934 -0.675971 8.59173 +524 2 4.064 15.4281 8.88095 5.53492 -3.39313 -4.80569 +525 2 4.98866 14.7298 9.93327 -5.1567 4.83883 -4.62826 +526 1 7.25259 2.18349 14.6213 0.0617677 -13.2081 -4.74626 +527 2 7.15489 1.70536 13.7831 -3.1697 0.657011 7.79217 +528 2 7.60954 3.02479 14.3607 5.63067 15.2107 -2.58221 +529 1 18.5424 14.6505 2.1789 -18.2195 12.8357 -3.23587 +530 2 0.746704 15.0923 2.14855 14.3998 1.01071 2.70778 +531 2 17.888 15.3836 2.15154 2.4051 -14.4939 -0.146303 +532 1 9.96619 2.7451 12.9133 2.94451 10.1866 18.8487 +533 2 9.87163 2.03702 12.2777 -5.79326 -7.02869 -14.8001 +534 2 9.15272 3.27293 12.9211 3.46257 -1.15836 -6.04557 +535 1 2.89008 8.93457 13.069 -0.378913 -4.03455 -0.489948 +536 2 3.23396 9.82093 12.8894 1.3587 3.50504 -2.14294 +537 2 3.63423 8.44035 13.4383 1.00579 -2.11175 -2.13579 +538 1 3.23705 8.4538 3.70316 6.66602 15.0067 -51.1451 +539 2 3.68898 9.21355 3.2191 -13.1992 -22.9024 22.1933 +540 2 3.37321 8.55056 4.62635 6.35333 11.1623 30.2444 +541 1 5.63533 7.19464 8.56829 15.13 5.19196 -11.3333 +542 2 5.75579 6.23215 8.63413 -6.09463 5.83127 4.58457 +543 2 5.06463 7.50349 9.27803 -5.30623 -7.19668 4.50769 +544 1 14.8805 1.37043 1.98087 -12.9306 20.6627 -0.801435 +545 2 14.4834 2.20569 2.28334 5.69168 -11.9007 13.5915 +546 2 15.1168 1.59638 1.09054 15.1066 -6.121 -14.4277 +547 1 8.35206 15.1867 0.801551 -2.76223 -14.7585 -5.29804 +548 2 9.12264 14.9643 1.32951 11.031 8.33032 8.58299 +549 2 7.67017 14.6008 1.15941 -5.63761 -0.337967 -3.00039 +550 1 15.5896 1.3528 7.2086 5.32958 13.3681 13.2076 +551 2 15.0272 0.817571 6.66531 -11.4451 -13.4108 -9.89715 +552 2 14.9993 2.0562 7.52457 4.21653 3.3566 -1.64766 +553 1 5.02591 13.0452 18.4884 -9.20414 -3.59717 -21.6247 +554 2 5.46138 13.1397 0.681872 7.63488 2.92653 16.7381 +555 2 5.72796 13.1696 17.8326 -7.15584 3.38504 4.08457 +556 1 15.3795 8.51367 18.1423 -0.613664 -0.0581633 13.6311 +557 2 15.7206 8.99589 17.3938 3.47957 9.7554 -12.9134 +558 2 15.3333 9.18442 0.205917 -4.60531 -6.1888 -2.54679 +559 1 12.0939 3.05244 18.336 -15.98 21.6351 4.66001 +560 2 12.5019 2.66242 0.476891 0.147771 -8.75739 -8.71627 +561 2 12.3559 2.60872 17.5248 9.46456 -12.7769 5.34739 +562 1 13.1875 12.6757 5.16147 -9.52799 6.20775 -2.46737 +563 2 13.6969 11.8811 4.95337 3.5398 -1.69434 3.58065 +564 2 13.2525 12.8475 6.11376 6.90446 -8.64397 -1.04625 +565 1 6.03627 7.1613 0.0926319 -1.4976 11.1377 0.14104 +566 2 5.76921 8.10211 0.154014 9.70457 -9.32393 -3.08293 +567 2 5.20613 6.68485 0.159604 -1.55619 -3.41243 3.21991 +568 1 17.685 15.9184 14.9825 -1.37425 0.537856 -17.3926 +569 2 16.8502 16.3506 14.966 -20.4161 12.6054 20.7942 +570 2 17.7239 15.7506 14.0369 24.1644 -10.6132 -5.26117 +571 1 13.1805 0.948047 16.6125 -8.26177 1.73564 3.5107 +572 2 14.0455 0.715926 16.9626 7.25254 0.595142 -3.17693 +573 2 12.7267 0.0993777 16.5408 2.533 -1.4889 -4.3323 +574 1 11.0204 14.5878 7.33132 -13.7805 -25.7938 -0.586216 +575 2 10.2983 13.987 7.62969 9.87943 15.8321 -1.01987 +576 2 11.8217 14.058 7.45361 -0.254224 3.6388 3.5388 +577 1 17.5119 8.53957 2.08465 9.75653 -12.9638 -10.6953 +578 2 16.6633 8.36471 2.52368 3.0717 -2.74041 -4.8374 +579 2 17.6343 7.8268 1.40004 -7.84255 17.4574 20.9547 +580 1 12.3495 7.93856 1.97915 15.2682 -24.1922 3.95646 +581 2 11.8245 8.73298 1.97607 -8.33179 10.3297 -5.28986 +582 2 12.0289 7.32679 1.29658 -2.64171 9.95394 1.06163 +583 1 11.9622 14.6462 10.3592 5.19436 44.1652 25.6085 +584 2 12.1561 13.8266 9.98193 3.67183 -41.4058 -22.2867 +585 2 11.0169 14.8072 10.2884 -7.2612 -3.28322 -4.25289 +586 1 6.85285 6.99572 15.5659 -14.0155 -24.0568 -12.8099 +587 2 7.75988 6.91015 15.2685 9.48733 7.04308 1.07731 +588 2 6.80041 7.76332 16.11 4.63477 18.9896 15.1539 +589 1 8.01222 4.65145 13.4113 -36.8067 -34.3033 -31.6859 +590 2 7.3316 4.83402 12.7007 16.1602 -3.60309 24.697 +591 2 8.38377 5.47541 13.6286 15.6027 34.5994 6.21753 +592 1 13.4241 12.174 14.3057 -4.84328 6.02619 2.2323 +593 2 13.1628 11.2453 14.2138 0.984992 -0.986947 -4.38535 +594 2 13.8661 12.446 13.4834 -0.550032 -4.72607 1.54363 +595 1 14.7341 9.44221 7.2791 -5.07947 3.15833 13.2143 +596 2 15.5444 9.94699 7.52972 -16.5583 -4.09464 -2.76463 +597 2 13.9842 9.66778 7.87655 21.0159 1.38057 -11.435 +598 1 12.706 16.9897 3.14089 12.6698 -33.6085 3.29803 +599 2 12.7844 17.2146 4.05845 5.40916 5.57996 15.4808 +600 2 12.1668 17.6603 2.78193 -20.8699 29.0634 -19.4792 +601 1 1.09001 7.14262 17.4001 -13.5934 2.13623 7.48936 +602 2 0.156991 7.24832 17.6908 14.7769 -7.58529 -2.77652 +603 2 1.13731 7.55625 16.5284 -2.3111 1.37932 -0.487878 +604 1 12.8562 5.06495 15.6988 -8.68567 -0.702669 -5.76624 +605 2 13.5471 4.4122 15.5538 8.1837 -6.12965 4.55719 +606 2 13.3218 5.91347 15.6395 -0.893164 2.09785 3.54679 +607 1 2.45402 3.36746 5.11563 -15.0026 -7.91555 0.636238 +608 2 1.84292 3.24382 5.86687 4.72922 -2.7794 -8.95345 +609 2 2.91216 4.18226 5.3072 9.55717 10.9124 5.44962 +610 1 8.31869 11.1649 13.5414 -26.3953 31.2189 -67.0184 +611 2 8.3305 10.9362 14.4299 14.6498 -23.9054 54.2316 +612 2 8.96182 10.7076 12.9898 15.0794 -7.45176 14.931 +613 1 12.9219 1.43726 13.3082 8.40674 -27.4269 12.3988 +614 2 13.6356 1.33586 12.6838 7.08718 -5.3 -10.143 +615 2 12.6036 2.28403 13.0872 -17.61 33.9058 -2.44667 +616 1 6.45277 13.6094 2.15178 17.7292 -13.553 0.669437 +617 2 5.88225 13.9257 2.84987 -12.2826 9.62032 8.12495 +618 2 7.05696 13.0019 2.62135 -3.25561 7.9246 -7.28354 +619 1 15.9319 6.53462 12.7261 -1.3149 8.22476 -13.019 +620 2 16.4256 7.00237 12.02 -4.18033 -7.18445 13.3481 +621 2 16.3662 6.74364 13.5705 0.249391 -3.37031 -2.78146 +622 1 16.8119 0.703827 9.59317 0.0549178 13.2549 -11.7388 +623 2 16.9772 18.4048 9.65541 -4.88295 -11.6626 5.05601 +624 2 16.4803 0.847119 8.68154 -1.08178 -1.2883 7.79904 +625 1 6.11652 11.6489 8.33522 -7.45125 2.78057 4.10213 +626 2 5.22601 11.4682 8.68918 7.08294 1.77705 -0.544493 +627 2 6.44454 10.7788 8.07724 4.19277 0.895061 -4.04259 +628 1 2.82334 8.71064 0.367814 57.5944 7.33247 25.2144 +629 2 2.2601 8.16366 18.5098 -36.527 -13.587 -20.7071 +630 2 2.37171 9.41868 0.829256 -17.9324 0.137834 -3.43482 +631 1 10.1122 10.4601 6.54653 2.23323 -6.08635 8.59596 +632 2 10.5188 9.74717 7.06727 -1.60105 2.20328 -1.71973 +633 2 10.6949 10.5759 5.79445 1.91861 -2.10956 -11.6412 +634 1 6.75321 15.7504 6.59889 15.4627 0.902891 -8.22878 +635 2 7.26857 15.9454 7.3825 -2.17992 1.48032 8.28293 +636 2 7.22097 16.2558 5.90647 -13.1985 0.138133 2.05084 +637 1 6.44152 13.0383 5.65846 10.3967 8.14078 0.466175 +638 2 6.75357 13.9433 5.8413 -7.70657 -8.59676 1.70002 +639 2 6.06189 12.7174 6.48437 -0.213232 -3.44089 0.434225 +640 1 16.7867 12.5398 9.78373 -0.895423 12.3409 14.8939 +641 2 16.908 11.9251 9.05274 5.68732 0.178616 -8.50939 +642 2 17.2058 13.3939 9.58039 -4.06144 -12.2084 -5.14549 +643 1 6.11722 2.93773 2.78358 1.28645 13.216 -7.71479 +644 2 6.25944 3.86133 2.4934 3.99356 -9.45804 11.966 +645 2 5.80949 2.50246 1.9813 -4.27697 -8.38821 -0.209888 +646 1 10.8697 3.19981 3.26527 3.50346 -2.80617 2.55973 +647 2 10.3917 4.00785 3.47818 -6.11785 -2.03152 -1.59068 +648 2 10.4869 2.83625 2.45753 -2.48553 0.910808 2.03729 +ITEM: TIMESTEP +50 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.80494 6.94654 17.8995 24.4982 -1.06408 -3.00226 +2 2 7.9626 7.14317 18.2754 -25.5132 0.779993 7.28642 +3 2 8.754 6.09075 17.4755 -3.81212 -4.80634 -6.17786 +4 1 18.7076 8.28828 6.77862 -17.6183 19.7289 -45.7057 +5 2 0.378325 8.05756 5.8509 -9.14495 4.02657 32.4311 +6 2 0.533056 7.77742 7.41073 20.0311 -22.8668 16.2585 +7 1 8.47587 18.7144 6.8555 -15.9357 -0.720841 9.56566 +8 2 9.33674 0.260611 6.50709 17.8925 2.772 -5.71063 +9 2 7.894 0.699709 6.41588 1.40147 0.745568 -0.352682 +10 1 6.55032 1.74908 11.6806 -30.6389 -0.0206495 8.42613 +11 2 5.72229 2.20254 12.0188 30.9536 -14.8428 -8.23206 +12 2 6.26581 0.83583 11.4478 2.55871 18.5754 3.76962 +13 1 7.01034 5.66598 2.40366 42.8029 -38.9731 -13.6875 +14 2 6.35895 6.02285 2.96016 -30.9745 25.4116 27.1882 +15 2 6.9342 6.07183 1.55014 -9.7244 15.1829 -13.9093 +16 1 16.2046 10.2277 16.1038 24.2393 -12.7483 3.49627 +17 2 17.1446 10.5017 16.2161 -25.4373 -4.23616 -6.12234 +18 2 15.647 10.9645 16.3441 -0.0961828 13.5193 2.91036 +19 1 10.6483 14.9468 2.32679 16.6528 15.7411 4.7381 +20 2 10.6274 14.3584 3.09768 -0.623134 4.2367 -1.18236 +21 2 11.2712 15.6715 2.59359 -14.1521 -13.9994 -5.33424 +22 1 17.1661 8.23718 10.6306 -11.2967 1.73071 14.301 +23 2 16.7507 8.8212 11.3018 1.93853 -3.53361 -12.158 +24 2 17.9019 8.73965 10.2686 8.0864 2.26419 -0.719652 +25 1 14.7146 15.8737 16.457 -21.3602 13.4439 -13.9077 +26 2 13.7676 16.1527 16.3582 25.6738 -5.80999 2.03747 +27 2 14.7447 15.4629 17.3289 2.78446 -2.53877 0.107495 +28 1 12.1127 13.3961 0.516068 7.29043 -9.0569 -3.36162 +29 2 11.9491 13.4845 18.198 -4.88029 1.64951 11.237 +30 2 11.4672 13.8878 1.04861 1.29785 5.2885 -8.15688 +31 1 9.32313 5.46813 3.97213 7.80738 6.41636 -30.8752 +32 2 8.77956 5.22076 4.69796 -14.0602 -7.63701 27.6376 +33 2 8.66617 5.58024 3.26537 2.47672 -2.22308 0.129141 +34 1 1.75935 4.12111 11.6197 18.1342 -37.205 15.7411 +35 2 1.54791 5.00495 11.8916 -2.97584 25.4072 4.68628 +36 2 2.32145 3.72177 12.3424 -17.0092 10.631 -21.3466 +37 1 2.03979 6.80407 8.28533 9.98525 11.4794 16.6393 +38 2 2.53906 7.28349 8.98677 -9.97253 -7.08615 -13.1486 +39 2 1.84044 5.93856 8.67612 2.99865 2.8006 -7.53122 +40 1 5.41368 4.4431 7.98609 2.04847 -7.17668 -5.4397 +41 2 5.52021 3.53426 7.6768 1.69988 -8.04832 10.7211 +42 2 4.8597 4.83563 7.32005 -13.574 8.98698 -13.1921 +43 1 3.28639 2.94557 17.481 18.7711 -22.2673 -22.0629 +44 2 3.9564 3.24513 16.8336 -6.74837 -1.29983 9.82734 +45 2 3.01936 3.73284 17.9334 -14.3576 17.7403 14.3716 +46 1 7.43065 5.38409 6.1108 -4.02947 -12.3157 -7.88053 +47 2 8.04294 5.88377 6.62432 18.8075 23.5792 8.00277 +48 2 6.91671 4.96856 6.79731 -10.3369 -11.1081 4.55684 +49 1 9.79016 6.98523 11.9902 -10.4204 5.88316 -11.2143 +50 2 10.3735 6.44493 11.4296 -8.50476 3.87141 4.17676 +51 2 9.02941 7.28204 11.4255 18.3189 -8.29917 9.01359 +52 1 14.0741 3.64931 8.08693 10.5401 -0.215179 40.0548 +53 2 14.0167 4.44403 7.56769 -3.75439 10.9765 -10.3635 +54 2 14.3054 3.9684 9.00291 -5.13065 -9.75311 -28.2231 +55 1 4.53282 17.2396 3.96388 -3.36194 -12.9595 16.5635 +56 2 5.47422 17.3897 3.95236 14.0752 8.1678 -3.62607 +57 2 4.10275 17.6636 3.22639 -0.935466 5.38311 -16.6052 +58 1 16.4462 16.5922 10.2581 -38.5234 -1.88036 17.4962 +59 2 15.5721 16.6729 10.7424 33.2408 0.640367 -11.4138 +60 2 16.1948 16.0519 9.4989 1.36351 -0.703045 -4.07641 +61 1 1.99534 4.82647 0.326236 -5.72725 6.00108 -15.6714 +62 2 2.53752 5.17962 1.03714 5.87953 4.50688 4.90779 +63 2 1.76739 5.60304 -0.220726 -2.02535 -4.08014 4.56707 +64 1 11.5531 13.2812 16.3325 -4.55485 8.80091 5.86354 +65 2 11.0534 12.4701 16.4457 -6.69668 -7.45166 4.31247 +66 2 12.0841 13.1031 15.5561 8.82157 3.01133 -6.78989 +67 1 10.1577 11.0139 16.8858 -24.3839 23.6532 0.592397 +68 2 10.5791 10.1721 16.8528 10.3809 -28.4273 -2.47871 +69 2 9.20446 10.8554 16.7431 9.15295 -0.788439 1.53623 +70 1 11.769 17.4436 13.4724 -4.31264 31.1905 -3.85112 +71 2 12.3451 17.016 12.8258 4.51875 -1.42135 -0.782751 +72 2 11.9049 18.418 13.331 2.02313 -21.8103 4.25856 +73 1 6.43699 9.33747 12.2016 -14.3685 16.3251 29.571 +74 2 6.95929 8.94901 11.512 13.8657 -1.33735 -10.2504 +75 2 6.99936 9.91985 12.7612 -5.52999 -10.4188 -15.163 +76 1 16.2506 12.8362 2.68463 10.4823 17.07 -2.68352 +77 2 17.0784 13.3466 2.55935 -9.20242 -14.0812 1.4249 +78 2 15.565 13.5285 2.65461 0.126865 -8.38924 5.57615 +79 1 0.688432 12.6159 5.91845 40.3739 4.73102 13.6953 +80 2 0.965548 12.5027 5.00914 1.60296 -4.44104 -10.7732 +81 2 18.4099 12.7183 5.90627 -44.0147 0.977299 -7.7541 +82 1 5.23962 16.4285 18.4285 2.37714 -1.84876 8.0205 +83 2 5.78786 15.7427 18.0572 3.65919 -12.8888 -12.968 +84 2 5.57695 16.4825 0.678793 -3.22986 7.92557 6.36641 +85 1 0.598604 7.70507 4.14138 -20.7786 -13.2635 7.16681 +86 2 18.6305 8.09263 3.50172 -0.345103 1.12768 -4.13337 +87 2 1.46117 7.8354 3.77399 24.2365 9.84596 -7.22116 +88 1 3.12664 8.94501 6.49467 58.7355 2.96877 -21.5552 +89 2 3.79065 8.46432 7.02112 -12.6266 6.35685 -1.15291 +90 2 2.29097 8.86083 6.88074 -41.9399 -6.12221 23.1652 +91 1 7.26988 10.3368 16.2836 11.5372 -0.463039 -18.2668 +92 2 6.61986 10.5879 15.6307 -2.48374 3.02842 -3.04887 +93 2 6.78814 10.3049 17.1036 -3.00573 -3.18181 16.2709 +94 1 11.123 0.978368 5.0094 -10.4546 8.12706 3.20432 +95 2 11.0717 1.86722 4.62246 7.34447 -2.45893 1.30193 +96 2 10.765 0.419141 4.31729 -2.84542 -7.68945 -6.73121 +97 1 4.36745 2.7997 13.2283 -2.96005 27.1446 -27.16 +98 2 4.67681 3.13482 14.0684 -0.492375 -1.19152 9.60175 +99 2 4.17697 1.87548 13.305 -2.22526 -24.419 13.8486 +100 1 8.37947 10.1962 1.80259 -4.93469 16.4683 -10.3397 +101 2 8.22749 10.8872 2.46356 1.16914 -1.49574 -1.6966 +102 2 8.71062 9.47199 2.30942 8.47484 -21.3721 12.0127 +103 1 10.3811 1.71408 15.5377 20.686 0.359172 -10.6925 +104 2 11.354 1.66546 15.4316 -15.8773 -5.06945 10.6173 +105 2 10.0964 2.02238 14.6685 -5.35844 0.742925 -2.36882 +106 1 2.68357 12.8347 7.81396 4.59418 8.51704 7.17464 +107 2 3.18489 13.5948 7.4697 -3.72618 -6.19027 -0.541735 +108 2 1.90686 12.7457 7.24856 2.42229 -2.05385 -5.50174 +109 1 3.74169 11.6981 5.12659 20.4064 16.2552 5.07347 +110 2 3.6031 10.8525 5.51837 -2.34348 -17.0347 14.1119 +111 2 3.05756 11.7956 4.48632 -17.1397 4.43934 -14.0111 +112 1 6.78306 14.4202 16.945 8.30127 18.455 -2.7408 +113 2 7.70256 14.7228 17.0235 -7.00262 -4.27134 -0.857039 +114 2 6.4289 14.8468 16.1479 2.30915 -9.19793 -2.69046 +115 1 14.2185 14.5268 3.31588 -23.2154 9.18115 10.9982 +116 2 13.6682 15.2954 3.06852 12.5657 -5.26706 1.63848 +117 2 13.7604 14.1667 4.10581 9.83524 -2.33371 -14.8176 +118 1 8.44676 18.1227 16.0393 7.73472 16.3177 -1.68025 +119 2 9.01165 17.3799 16.1525 3.2644 -34.6246 10.2309 +120 2 9.11477 0.14931 15.8801 -4.9724 20.6673 -2.43491 +121 1 4.70679 1.64341 4.91058 -17.3364 -32.3489 41.2122 +122 2 3.86106 2.04855 5.10849 -6.14561 5.35271 -2.51022 +123 2 5.03045 2.1011 4.1778 23.045 28.1017 -39.82 +124 1 14.9769 12.6712 16.4491 28.5182 -25.5733 -37.1858 +125 2 14.5585 13.1664 17.1249 -24.0861 16.0366 17.7329 +126 2 14.4092 12.4828 15.6576 3.30334 14.0855 25.2157 +127 1 15.7195 18.4537 16.8862 -41.4911 -4.79998 -47.5194 +128 2 16.474 18.4695 17.416 41.6971 -5.3201 37.0536 +129 2 15.5173 17.5216 16.6763 -0.165283 4.31671 10.9236 +130 1 1.26675 1.20722 16.5821 1.91531 -3.73727 -7.96899 +131 2 2.06576 1.68562 16.7995 9.77153 8.32265 -0.296149 +132 2 0.695796 1.45596 17.2985 -12.9769 2.74169 12.7471 +133 1 18.1595 4.46894 15.9392 -8.68238 9.49864 15.6389 +134 2 18.21 4.01948 15.1094 2.12602 -9.4702 -15.5502 +135 2 0.321646 4.30297 16.4236 6.52219 -0.344151 0.382064 +136 1 12.2433 16.9631 16.1365 30.1535 25.9085 -42.0202 +137 2 11.4764 16.7912 16.6244 -43.4812 -17.6238 21.6018 +138 2 11.9609 17.1491 15.2014 5.35486 -10.4534 20.1012 +139 1 16.0404 2.55502 18.1172 12.6912 -10.4842 9.42679 +140 2 15.6589 3.39683 18.3503 -6.59057 14.1496 4.33812 +141 2 15.9441 2.46009 17.1755 -7.16214 2.08136 -15.1428 +142 1 6.70635 13.8458 10.192 -16.5385 -19.5662 -16.6234 +143 2 6.46743 13.4829 11.0519 3.62966 4.37567 6.36784 +144 2 6.41781 13.1513 9.56037 11.5929 10.5707 5.5488 +145 1 10.1419 18.3987 2.73425 -19.4638 -25.4286 12.0097 +146 2 10.2073 0.494584 2.15475 6.00155 18.7458 -18.7245 +147 2 9.2799 18.0069 2.48337 13.6051 6.39322 6.25061 +148 1 3.04438 17.7185 6.11283 5.61436 7.93422 -10.0091 +149 2 2.18521 17.5434 5.71014 -2.22655 1.93918 -4.29169 +150 2 3.60431 18.0006 5.35738 -6.06642 -9.44159 14.8188 +151 1 12.59 16.8727 7.99688 3.41749 0.26688 0.968442 +152 2 11.9163 16.1959 7.96054 -9.29683 -10.0995 -8.1817 +153 2 12.3648 17.371 8.78825 5.01363 9.11979 0.25951 +154 1 14.8925 15.2941 8.21002 11.8118 0.190541 -21.4145 +155 2 14.0466 15.7377 8.15471 -7.99071 7.70949 7.81769 +156 2 15.2804 15.4945 7.32486 -0.0803457 -7.85257 22.8773 +157 1 17.7158 18.2428 0.330134 42.1686 22.2301 9.80157 +158 2 18.5718 17.7519 0.320787 -20.6577 0.0591745 -9.59458 +159 2 18.0296 0.514827 0.540707 -19.3386 -19.3229 -5.27308 +160 1 0.848087 10.4587 1.36302 27.1846 51.9138 -28.6855 +161 2 0.125428 9.973 1.66463 -44.0007 -34.6793 17.9508 +162 2 0.450253 11.2027 0.827225 17.544 -22.8417 14.6566 +163 1 1.73752 12.2317 3.35921 -10.6222 -3.23772 -40.3174 +164 2 1.50468 11.5771 2.65039 3.80547 3.73659 24.0112 +165 2 1.78112 13.0447 2.82871 4.93945 -0.670418 11.0651 +166 1 0.61763 17.2312 4.89977 -31.3278 9.09129 49.7394 +167 2 18.753 18.067 4.93438 12.2337 -8.61092 -13.4292 +168 2 0.309388 16.8063 5.75223 19.8395 0.744545 -34.548 +169 1 1.12081 0.925337 9.40389 -12.5044 -10.6635 0.652446 +170 2 1.34187 0.581545 10.2981 -6.32089 4.74016 -12.6461 +171 2 0.253358 0.524348 9.17819 18.5788 9.22491 5.8567 +172 1 16.7331 2.36195 13.2995 -4.07693 -18.6231 24.2357 +173 2 16.9587 2.56306 12.4093 5.05193 8.99127 -27.3142 +174 2 16.5121 1.41005 13.3069 2.86591 9.33714 2.00751 +175 1 2.6752 15.8404 12.084 -17.9655 13.8891 -13.7444 +176 2 3.1007 15.4046 12.7977 10.8605 -10.5552 20.9848 +177 2 3.18035 15.6022 11.2985 0.61387 1.79975 -2.62876 +178 1 16.4324 15.6688 6.07894 -11.0906 -29.1832 8.11987 +179 2 17.3135 15.6699 6.4691 2.82688 3.86386 -3.5648 +180 2 16.3493 16.3586 5.42897 4.86465 16.2346 -9.8305 +181 1 5.78229 5.11191 11.8099 -13.8406 10.2937 3.29755 +182 2 5.26053 5.84491 12.2174 12.8802 -11.8636 -2.84442 +183 2 5.17337 4.36282 11.7377 2.58239 3.92087 3.15374 +184 1 15.1463 4.86734 0.794152 0.864651 12.4924 -33.9562 +185 2 14.9842 4.50309 1.65022 -3.17819 -5.74322 26.2661 +186 2 14.3662 5.39647 0.571272 5.91156 -4.56503 2.45287 +187 1 16.3343 16.3902 2.05204 -8.53913 3.9795 31.3204 +188 2 16.0972 16.7844 2.93864 3.99019 -13.2916 -26.145 +189 2 16.6713 17.1379 1.5654 4.18336 9.27065 -12.2854 +190 1 0.251768 4.84384 3.8243 -5.07672 -49.1083 -0.618349 +191 2 0.303365 5.75864 3.98841 7.12191 44.1717 7.46524 +192 2 0.849427 4.39339 4.43966 -1.76195 8.48948 -7.42491 +193 1 2.97026 15.0637 15.1648 0.961584 14.1925 -19.6325 +194 2 2.86359 14.8338 16.0871 -5.01806 -10.0022 10.5852 +195 2 2.57214 15.9549 15.1104 2.70735 -9.48442 0.706884 +196 1 1.14871 14.6442 9.53518 -42.8529 -19.211 3.24989 +197 2 2.06628 14.849 9.52706 28.3433 -3.949 4.37311 +198 2 1.01023 13.7361 9.90627 12.772 19.4662 -8.86837 +199 1 13.5229 16.5669 11.532 20.3549 -23.4698 16.7524 +200 2 13.3606 17.2446 10.8944 -12.6142 15.9017 -14.8664 +201 2 13.2357 15.729 11.1267 -5.06335 10.0173 1.96475 +202 1 4.64907 1.44855 0.782556 14.1843 16.2277 -15.4645 +203 2 4.13811 2.00007 0.175187 -1.198 1.13782 0.731863 +204 2 4.05002 0.760268 1.05534 -6.36237 -9.04178 10.9284 +205 1 1.45269 18.5669 11.8512 9.08594 -18.5638 20.5671 +206 2 1.3209 0.513151 12.6112 1.192 -1.45307 -0.682323 +207 2 1.82538 17.7349 12.2384 -6.22294 17.2853 -13.4176 +208 1 11.5083 10.14 3.99231 -12.3356 -6.67004 24.2683 +209 2 11.3008 10.4626 3.12291 -1.30093 6.41155 -12.7666 +210 2 12.4624 10.1697 4.04844 12.7044 -2.53047 3.95194 +211 1 8.22637 12.1595 3.70182 22.1984 -6.43536 -24.1249 +212 2 9.06359 12.543 3.994 2.39995 3.52197 1.898 +213 2 7.64229 12.2644 4.4292 -22.7553 4.87752 31.4773 +214 1 14.5041 4.04055 3.28708 -18.3332 1.47774 -0.327682 +215 2 14.9873 3.94029 4.11097 10.9182 2.80533 4.02706 +216 2 13.7169 4.55783 3.53097 2.05743 -3.46177 -0.871318 +217 1 5.62743 1.64825 7.52429 33.006 28.3977 -54.9531 +218 2 5.01294 1.12929 7.98513 -35.2623 -28.0367 23.7041 +219 2 5.43705 1.49837 6.5464 4.70081 6.15592 32.4881 +220 1 17.8649 1.10253 4.84999 -3.85271 -3.04411 9.89583 +221 2 18.5316 1.48406 4.28754 10.0589 0.579138 -13.4652 +222 2 17.9089 1.63153 5.65146 -2.44801 0.268727 5.2117 +223 1 6.82865 9.41118 4.50161 13.9732 -1.80028 18.7676 +224 2 6.94383 9.68391 5.43824 -8.65407 -5.40133 -16.2957 +225 2 7.70845 9.07477 4.25578 -5.27921 1.965 -0.840285 +226 1 2.66065 14.8943 1.98186 -2.57221 -9.24308 25.7982 +227 2 3.31586 14.7955 2.69868 -8.68087 -2.61777 -7.29774 +228 2 3.12007 15.367 1.30687 7.03004 7.53846 -18.6884 +229 1 17.3318 12.9277 13.2024 14.566 -8.41998 -6.98679 +230 2 16.4646 13.2932 13.3909 -3.11164 10.4066 0.365823 +231 2 17.9245 13.6681 12.9725 -15.6789 -3.68206 1.74475 +232 1 14.9332 10.5631 1.42248 26.9386 23.5346 15.1493 +233 2 15.5074 11.3103 1.7869 -22.4798 -24.8917 -12.2482 +234 2 14.0193 10.8096 1.5708 -2.19259 1.9486 -0.294463 +235 1 5.71089 6.73608 4.5629 -4.22281 28.118 -3.03355 +236 2 5.94827 7.69445 4.64343 -4.82413 -18.183 -7.3163 +237 2 6.31292 6.28304 5.16113 4.14578 -2.25186 0.1588 +238 1 7.97883 8.3192 10.3001 7.8407 -5.86676 -34.7961 +239 2 8.53275 9.01778 9.91692 4.61581 1.53144 9.76809 +240 2 7.67805 7.86001 9.48783 -4.88471 -0.599295 18.8237 +241 1 13.4226 18.4487 5.72909 4.08913 1.21656 -6.98532 +242 2 12.585 0.250804 5.52036 7.76092 4.80861 -0.84516 +243 2 13.2097 17.9386 6.50687 -2.642 -10.6174 11.5339 +244 1 0.0869602 2.62265 0.223952 -9.8031 -15.3274 -6.51765 +245 2 17.9117 2.88521 18.4333 -9.97249 -6.92357 5.22107 +246 2 0.604672 3.41479 0.198655 20.2406 16.0872 6.75582 +247 1 12.7806 11.0275 9.75202 47.836 -29.2198 23.6504 +248 2 11.892 10.9606 9.4924 -44.5823 -3.62186 -10.7645 +249 2 12.9839 10.1194 10.1272 -4.83434 23.2951 -13.1663 +250 1 0.705171 12.1501 11.0469 -11.5221 2.5881 -10.739 +251 2 18.3743 12.1368 11.1638 13.8029 4.27958 5.25964 +252 2 1.13401 12.4861 11.8379 -3.00537 2.27024 12.2218 +253 1 5.1174 7.31342 13.4172 11.1181 3.69095 0.765545 +254 2 5.61979 7.99643 12.9358 -2.94992 -2.73128 4.30069 +255 2 5.6521 7.15272 14.218 -5.77355 -1.15348 -7.33249 +256 1 1.197 6.86571 11.8595 38.3077 26.916 14.5555 +257 2 0.451078 7.27927 11.4324 -8.7071 4.85333 -5.01967 +258 2 1.83731 7.62187 12.0983 -31.0022 -32.2106 -6.42275 +259 1 15.4885 9.63727 12.3206 16.478 -29.8614 -10.1392 +260 2 15.1661 10.5006 12.1398 -12.0715 29.4427 -0.903292 +261 2 15.2587 9.41843 13.2151 -2.74274 1.51694 14.7591 +262 1 16.5678 12.6919 5.49509 2.68502 5.28083 21.2685 +263 2 16.324 13.6184 5.59953 -0.326156 6.48336 2.9395 +264 2 16.4016 12.5196 4.57887 -2.84479 -5.20052 -25.0662 +265 1 6.28213 9.87258 0.0490999 16.8985 1.83912 15.6964 +266 2 5.56262 10.3905 0.421328 -3.89363 2.12479 6.12138 +267 2 7.01982 9.90555 0.722608 -19.7924 2.8001 -17.1777 +268 1 12.2865 6.1036 4.06304 19.2748 24.5544 -29.5048 +269 2 12.3306 6.8161 3.36437 1.4085 -17.3408 22.8012 +270 2 11.3814 5.83426 4.0192 -21.2841 -11.2083 4.33393 +271 1 0.298047 12.7955 0.166375 -3.43648 3.64279 0.0778505 +272 2 -0.0290314 13.4316 0.817326 3.1389 2.62115 2.93426 +273 2 18.4391 12.9788 18.0124 -4.25126 3.67416 -7.60949 +274 1 3.647 18.6117 8.59889 -15.5834 11.8668 6.1299 +275 2 3.50703 18.267 7.70639 0.18727 -3.89186 2.0216 +276 2 2.76186 0.338497 8.83167 17.7751 -6.65964 -2.12733 +277 1 7.50606 17.376 4.49824 -10.0508 -46.4512 11.7168 +278 2 7.49016 18.3059 4.51667 7.03352 43.591 -0.815572 +279 2 7.72157 17.1186 3.60818 -1.05523 3.68228 -12.2984 +280 1 9.25162 17.1195 12.2401 -20.7119 -1.17481 -13.1138 +281 2 9.34873 16.3083 11.723 0.965197 -1.09758 -0.258815 +282 2 10.0653 17.2534 12.7074 19.1017 -2.42392 11.5163 +283 1 13.35 12.9891 7.98546 26.3101 20.7404 -8.62941 +284 2 13.4089 12.1901 8.49273 -4.66259 -15.0904 10.7497 +285 2 14.2093 13.4501 8.17144 -24.2961 -0.252284 -5.87391 +286 1 14.9018 2.99422 15.3537 -18.6075 -8.06583 14.6174 +287 2 14.2375 2.30647 15.2045 2.81445 1.4476 3.5012 +288 2 15.4631 2.94521 14.5905 14.0528 3.89371 -13.7736 +289 1 9.86333 15.5824 16.9775 -1.70109 -0.0675876 9.27141 +290 2 10.3396 14.7637 16.7526 0.856458 3.65656 -1.57854 +291 2 9.55317 15.4797 17.8978 1.12056 -0.962034 -11.839 +292 1 11.2957 8.40029 16.577 -16.0633 -20.1101 7.86553 +293 2 10.6817 7.8482 16.0424 7.68237 12.4971 4.88138 +294 2 11.3251 7.92133 17.4322 4.78934 8.39937 -13.6138 +295 1 3.89281 18.1695 16.7848 -3.14598 -18.8551 -14.8366 +296 2 4.41813 17.5168 17.2844 -2.97968 13.5676 2.86087 +297 2 3.87713 0.360621 17.2331 6.32956 9.89438 13.0847 +298 1 2.18947 4.17934 8.91366 -18.0693 4.35017 -17.8699 +299 2 3.09766 4.08917 8.6846 23.1764 -2.78898 -7.58361 +300 2 2.16493 4.06394 9.84833 -5.05649 -4.17918 28.8808 +301 1 9.87375 10.372 9.69798 10.3489 -25.1121 17.1783 +302 2 9.47622 11.1704 9.40878 -10.9495 28.2307 -13.2887 +303 2 10.0218 10.4724 10.6474 2.61027 -3.39635 1.23761 +304 1 9.66501 0.904023 10.8717 -13.0386 -22.5074 -9.87351 +305 2 9.3051 0.0213231 11.0865 8.01248 8.88818 8.11202 +306 2 9.06191 1.19139 10.169 9.00305 9.82525 0.172013 +307 1 9.18563 15.0903 10.2115 17.1556 13.6164 1.72702 +308 2 8.73275 15.8289 9.78742 -0.477718 6.62954 -2.89772 +309 2 8.53792 14.3995 10.1946 -15.8858 -12.7719 2.13472 +310 1 0.946133 9.58267 10.2797 -17.999 7.07835 7.04569 +311 2 0.977457 10.4775 10.6382 -6.96742 -0.068666 -4.76802 +312 2 1.85682 9.38261 10.1843 21.4216 -13.3352 -8.00245 +313 1 16.9414 4.83421 8.13223 15.4014 12.0295 -27.8426 +314 2 16.4342 5.57084 8.44793 -11.0978 12.5109 2.31217 +315 2 16.8158 4.17203 8.77314 -2.49922 -25.6846 24.7871 +316 1 14.7535 14.7061 0.203986 15.073 4.98951 -2.11802 +317 2 15.1043 15.2916 0.890887 3.3452 -1.27018 2.88153 +318 2 13.9621 14.3164 0.552408 -18.4772 -7.94901 9.40987 +319 1 3.67958 11.0243 9.53991 2.98139 -0.929731 17.0732 +320 2 3.55398 11.294 10.4695 5.20942 3.18167 -4.3207 +321 2 3.23108 11.6955 9.00414 -3.72853 0.365488 -5.84942 +322 1 11.2021 10.759 1.44219 -17.3262 -13.0718 -7.65614 +323 2 11.58 11.5828 1.16251 10.55 19.7497 -9.01804 +324 2 10.309 10.7579 1.05212 6.07305 -2.69648 6.21388 +325 1 13.1662 7.17502 12.7531 25.9391 -3.29657 1.887 +326 2 14.1362 6.96154 12.7671 -19.0435 5.16748 0.470499 +327 2 12.7272 6.32599 12.8606 -4.03684 -6.30893 0.442018 +328 1 9.61497 1.86018 0.978015 -9.58691 9.0933 -29.7593 +329 2 8.82052 1.59363 0.443821 14.7013 3.9795 16.3864 +330 2 10.1598 2.41617 0.376969 -4.12787 -12.2318 8.97473 +331 1 10.6544 13.5231 4.58863 -13.6132 -6.73185 -2.44549 +332 2 11.4017 12.9559 4.77554 12.969 -5.04099 -4.5155 +333 2 10.624 14.0848 5.36102 -2.93668 8.13722 11.8558 +334 1 14.451 1.77042 10.9566 -5.06993 -21.3108 1.92478 +335 2 15.2282 1.34301 10.5576 -2.05514 6.77792 0.416034 +336 2 14.5487 2.7176 10.8324 3.84606 4.21375 0.609558 +337 1 14.5616 12.2019 11.6619 17.6804 1.81894 22.1071 +338 2 15.3038 12.427 11.1092 19.6924 5.46932 -2.69443 +339 2 13.8862 12.1117 11.0284 -35.3643 -9.54852 -21.0379 +340 1 8.20666 5.07147 9.84086 19.0973 -30.0877 -21.2342 +341 2 7.45963 5.1784 10.3955 -25.2729 10.7477 18.5337 +342 2 8.15765 4.10536 9.6198 7.47394 24.0469 -0.436218 +343 1 1.5637 16.9015 18.3956 -12.4387 -25.8837 12.5929 +344 2 2.10927 17.2609 17.7108 10.7809 10.3745 -20.1818 +345 2 1.47705 15.9462 18.1578 7.28008 19.3441 8.23831 +346 1 1.51254 17.2865 15.33 -55.1424 19.1245 13.5119 +347 2 1.44158 18.2256 15.6397 11.4216 -23.3977 -5.64032 +348 2 0.55797 16.9673 15.4072 37.0312 4.44622 -8.61518 +349 1 3.63692 5.75726 6.07961 7.7365 -18.3794 -8.43759 +350 2 3.1745 6.31944 6.69962 -9.61621 11.1355 4.40451 +351 2 4.08899 6.28836 5.40075 -0.121738 1.87808 9.22135 +352 1 12.4625 9.47055 14.2033 -9.88788 31.7301 7.89028 +353 2 12.9131 8.72585 13.8435 10.9703 -26.4307 -11.7769 +354 2 12.2412 9.2145 15.1039 -0.841012 -4.82452 5.58465 +355 1 4.05279 15.2823 6.91192 -35.0907 -10.5097 14.3913 +356 2 3.49702 16.0377 6.67476 5.8423 0.670453 -1.17602 +357 2 4.92638 15.5321 6.67665 32.7349 8.37925 -5.72993 +358 1 0.666426 8.62945 15.01 -4.81633 6.31993 2.8284 +359 2 0.390025 9.55783 15.0778 2.6081 -0.187855 1.05312 +360 2 1.36445 8.64555 14.3512 6.1817 -1.74341 -6.99991 +361 1 12.9834 8.27358 10.2916 -19.5051 6.59204 10.6567 +362 2 13.6375 7.73399 9.85191 12.7638 -5.94229 -3.5145 +363 2 12.8815 7.86968 11.1799 4.96282 8.38227 -11.7258 +364 1 15.3269 7.75333 3.56288 29.5219 38.2257 -22.8776 +365 2 14.5855 7.35684 3.13467 -21.9298 -17.371 4.59449 +366 2 15.5403 7.50003 4.45743 -10.8574 -16.6026 13.017 +367 1 17.2887 6.69393 0.021468 15.5778 -19.6292 8.74644 +368 2 16.7574 5.92192 0.248673 1.14134 -1.83764 1.32773 +369 2 16.6558 7.32534 18.3698 -22.9594 20.3863 -6.57681 +370 1 8.86981 6.94597 7.81474 24.2415 27.8548 -9.55577 +371 2 9.77577 7.36617 7.90295 -24.2622 -15.8521 -2.69303 +372 2 8.7837 6.29392 8.50186 -0.35036 -13.7271 19.3897 +373 1 12.3819 0.576227 1.23609 4.50683 -3.19553 -2.96149 +374 2 13.3476 0.534404 1.26268 -2.04299 5.45052 6.49319 +375 2 12.129 0.50298 0.316799 -1.00379 -2.5807 -2.54403 +376 1 5.62478 15.1294 14.5559 -8.95515 -20.8805 6.21096 +377 2 4.66749 15.251 14.733 11.0075 0.339747 -2.61971 +378 2 5.99586 15.9305 14.1948 2.79164 18.0184 -3.26028 +379 1 3.86891 6.41255 1.75203 -0.0773217 -5.81596 13.5476 +380 2 3.55695 7.28194 1.50076 -6.60469 12.2107 -8.14743 +381 2 4.09127 6.52195 2.68979 -0.816275 -1.80663 -6.76426 +382 1 3.9342 11.5843 12.3776 -18.6931 -4.72392 -0.912594 +383 2 4.79227 12.0122 12.4616 2.30575 0.246561 2.78418 +384 2 3.29871 12.1178 12.8946 9.72132 -5.51488 -9.32366 +385 1 5.32882 3.8676 15.8786 0.594801 -80.2026 -15.123 +386 2 6.00417 3.18473 15.5574 -21.0433 25.388 14.8589 +387 2 5.72544 4.69544 15.8213 26.1638 51.9163 -2.72297 +388 1 14.3304 10.2034 4.48175 -27.4096 24.8129 53.7077 +389 2 14.5884 9.79586 5.33863 -8.33179 4.59428 -12.4543 +390 2 14.8538 9.80174 3.84099 29.6706 -27.6476 -38.9945 +391 1 7.77951 17.4021 9.16969 8.83259 -7.31352 -4.45478 +392 2 6.90706 17.6601 9.4324 -15.0276 -0.0996042 12.8709 +393 2 7.95009 17.9588 8.40488 9.49987 1.3194 -6.72214 +394 1 4.51552 14.5162 3.99356 4.98181 -4.90212 -22.3913 +395 2 4.52626 15.4247 4.27156 -0.518589 17.7617 2.00307 +396 2 4.31207 14.0204 4.77138 -3.57212 -17.3619 18.7252 +397 1 14.1875 7.4375 15.7998 -22.901 -10.8896 -16.0938 +398 2 15.1146 7.35808 15.6286 24.9688 -1.25651 -4.60954 +399 2 14.1131 7.89225 16.6248 1.32628 8.65776 19.0596 +400 1 2.98527 18.3068 1.9119 -4.72699 -30.9822 -37.1172 +401 2 2.49826 17.7826 1.20191 12.7581 13.6458 27.4428 +402 2 2.34371 0.225349 2.32895 -15.9948 14.8465 9.72817 +403 1 8.01181 1.59883 4.56348 -29.7821 5.07108 -10.5683 +404 2 7.46781 2.03632 3.88017 -2.37558 -3.45248 10.775 +405 2 8.87859 1.65459 4.20584 24.9106 -1.40589 -4.13938 +406 1 2.43696 14.1424 17.6778 32.6678 8.55365 0.150748 +407 2 1.74447 13.6484 18.0869 -17.757 -15.5673 8.49591 +408 2 3.25626 13.7213 18.0204 -5.64692 6.54589 -2.94203 +409 1 0.856601 1.76819 13.8909 -34.0133 7.6587 12.0684 +410 2 0.79549 1.64555 14.8654 10.1884 -1.39389 -18.6264 +411 2 18.5699 1.97567 13.6249 24.5068 -3.80874 6.24474 +412 1 4.3972 0.0813689 13.9033 -13.8751 0.78744 16.7708 +413 2 5.2251 18.2898 13.7459 20.8939 -4.75733 -3.28132 +414 2 4.21678 18.5292 14.8441 -3.95615 2.50922 -10.6456 +415 1 7.163 0.723926 18.3524 28.8431 -20.8152 -22.3389 +416 2 7.29578 0.265373 17.4701 -6.89821 16.5948 25.8874 +417 2 6.28988 1.09447 18.4079 -18.4483 2.86302 0.00697782 +418 1 16.0461 18.4126 13.9592 23.9709 4.87143 24.0859 +419 2 15.127 18.3862 13.8391 -39.1169 -4.38354 -15.9017 +420 2 16.1011 18.5404 14.9193 8.5862 0.360016 -3.75437 +421 1 10.1416 4.5234 16.2814 33.6533 37.5162 -8.59515 +422 2 11.1148 4.69187 16.0483 -33.0569 -13.9639 15.4314 +423 2 9.96481 3.59397 16.253 2.9151 -23.0089 -4.34536 +424 1 15.9284 17.7644 4.42623 32.451 -11.9188 -9.4973 +425 2 16.5348 -0.134683 4.55752 -3.00893 1.73986 -2.0661 +426 2 15.0985 18.0471 4.75447 -36.3204 13.6328 11.8833 +427 1 7.01478 17.4412 13.8546 -37.2955 -8.85564 -21.6385 +428 2 7.52749 17.7553 14.5758 15.4879 9.12118 24.9138 +429 2 7.64547 17.2338 13.1683 11.7367 1.38126 -7.54157 +430 1 13.2517 6.48941 6.59541 21.6379 18.6409 -4.45059 +431 2 14.0732 7.02646 6.4901 -17.572 -15.5204 8.29538 +432 2 12.9904 6.33391 5.6816 -8.39128 -3.46546 0.217322 +433 1 7.82903 2.34082 9.30706 0.848413 1.46751 38.8479 +434 2 7.32489 2.17899 10.1397 9.78087 5.93227 -12.3925 +435 2 7.21411 2.12937 8.62642 -15.7826 -8.09866 -24.9258 +436 1 15.1931 14.7992 13.6996 5.60594 -14.9485 0.236255 +437 2 14.8724 15.0774 14.5533 -1.16755 2.2837 13.7936 +438 2 15.0044 15.5062 13.0994 -6.5851 10.7381 -11.5383 +439 1 9.39722 8.31385 3.80437 -4.07127 17.2834 -4.44624 +440 2 10.2713 8.68973 4.00761 -3.0526 -2.08627 -0.470344 +441 2 9.46128 7.36215 3.86627 5.27028 -8.92187 3.93672 +442 1 17.7859 13.5845 16.3834 -19.0466 -29.0207 18.2461 +443 2 16.8295 13.3731 16.3512 7.31415 3.8698 0.00611806 +444 2 17.8697 14.4051 15.917 1.12921 18.7325 -11.1152 +445 1 4.94376 10.5922 2.82245 -18.0715 22.8685 -14.9529 +446 2 5.66076 10.3167 3.37377 16.0421 -11.7082 13.1735 +447 2 4.72943 11.4907 3.12728 0.871258 -13.2337 -1.99455 +448 1 3.75648 8.36099 10.0882 -2.83158 17.8244 -9.78689 +449 2 3.88314 9.30809 9.8443 -3.15161 -16.2727 -0.870444 +450 2 3.74879 8.36585 11.0419 0.849549 -1.60464 13.0402 +451 1 15.9818 6.99244 6.07768 -13.3688 18.7296 1.03973 +452 2 16.7792 7.41732 6.38792 13.9106 3.61693 3.9934 +453 2 16.2026 6.08994 5.88298 6.53831 -20.9898 -2.75314 +454 1 15.1161 7.11481 9.04764 0.565665 -31.7989 38.5144 +455 2 15.8028 7.45918 9.62834 5.57768 4.61323 -0.34974 +456 2 15.1416 7.62578 8.27782 1.5606 28.4329 -39.6698 +457 1 6.26636 12.9592 12.746 15.2088 -10.2167 -2.30532 +458 2 7.09456 12.5046 12.9751 -5.12301 -5.10662 -0.512627 +459 2 6.13107 13.5604 13.4742 -6.25916 17.1748 9.55337 +460 1 12.1295 4.51914 13.098 -40.0586 -31.7334 -0.542355 +461 2 12.3128 4.55827 14.0372 7.66008 7.87672 6.17129 +462 2 11.3118 3.91999 13.0515 32.2373 26.2449 -7.62055 +463 1 11.3854 8.14886 7.92202 -18.4022 6.94815 -10.6415 +464 2 11.9487 7.53516 7.44565 12.5498 -6.92106 -4.31871 +465 2 11.7891 8.26504 8.77918 7.07043 -0.608458 13.7447 +466 1 17.1486 10.8722 7.52372 -29.3422 15.2924 19.4167 +467 2 17.741 10.1746 7.28593 21.144 -15.6164 -13.9006 +468 2 16.9754 11.4691 6.78151 4.60435 -5.53137 -7.06809 +469 1 5.26553 18.1239 10.9774 20.3802 -2.13667 -3.01104 +470 2 4.75345 17.8709 11.7323 -12.4512 -5.88679 12.7575 +471 2 4.64325 18.2391 10.2688 -13.5246 2.23536 -17.92 +472 1 7.60715 17.4884 1.7834 -2.49749 -8.82149 -34.1915 +473 2 7.92668 16.7242 1.2322 -11.5566 19.54 16.0619 +474 2 7.18999 18.106 1.13139 15.7932 -7.79309 14.6318 +475 1 1.92845 12.8983 13.5911 -4.1829 -6.61346 -8.43532 +476 2 1.49445 12.3761 14.2737 -4.42561 -3.96966 1.7572 +477 2 2.30088 13.6477 14.0465 3.83448 15.9215 12.3791 +478 1 9.57624 6.80131 14.8487 2.82943 -31.3701 -0.177857 +479 2 9.74438 5.86263 15.1368 -4.04832 25.5486 -0.431769 +480 2 9.80341 6.81631 13.907 0.113844 6.0265 -0.426062 +481 1 15.2789 4.31862 10.7553 12.937 12.8557 31.6205 +482 2 16.1415 3.96953 11.0436 -5.39931 0.983411 -21.2391 +483 2 15.1479 4.98349 11.4601 -8.5537 -3.88808 -14.9921 +484 1 11.2581 6.18474 0.159508 31.1076 25.8623 9.85053 +485 2 11.549 5.31982 18.5294 -8.46095 -20.0483 -6.31791 +486 2 10.3153 6.29854 0.132928 -17.8901 -6.88616 -7.00405 +487 1 -0.015613 11.3989 15.0155 5.52071 0.0143375 15.3818 +488 2 18.1286 11.6803 14.2478 -6.84029 3.18322 -8.47428 +489 2 -0.24984 12.0811 15.6717 7.42423 -4.02873 -7.86488 +490 1 7.04792 9.26093 7.28081 24.8295 12.5521 -3.74072 +491 2 6.59027 8.49663 7.6071 -13.7147 -18.0719 7.78469 +492 2 7.98742 9.01504 7.31689 -8.33941 1.9664 -1.88331 +493 1 18.3308 15.3469 12.3202 -6.03602 -2.26652 6.8961 +494 2 0.60478 15.4762 12.0772 12.6515 4.5696 -6.24084 +495 2 17.7927 15.7945 11.6538 0.941578 1.81095 -5.33876 +496 1 16.5149 4.38922 5.26132 -0.591505 19.7601 -54.4807 +497 2 16.8056 3.98806 6.0517 15.8153 -15.5532 32.6352 +498 2 17.2724 4.45951 4.61195 -16.46 -3.71476 24.2381 +499 1 17.705 3.15738 10.7395 -3.58994 -28.0349 -4.43916 +500 2 -0.0357658 3.31586 11.0143 13.799 7.93723 3.46651 +501 2 17.7252 2.25587 10.3433 -5.09014 14.337 3.42017 +502 1 12.282 -0.0102014 10.1171 1.80463 -26.6374 -6.99772 +503 2 11.3739 0.250254 10.2263 -16.4794 9.03176 6.86793 +504 2 12.791 0.759276 10.3145 17.2573 22.9944 3.87451 +505 1 10.3906 9.77529 12.4736 -11.6246 -18.6488 -11.2601 +506 2 11.1162 9.76462 13.0993 9.33947 3.77576 6.26492 +507 2 10.2448 8.81959 12.3007 0.540403 13.8663 1.27912 +508 1 0.620737 2.80838 7.04076 1.85552 -26.9198 -9.07562 +509 2 0.56001 3.58776 7.58035 -0.0658531 10.9425 14.6075 +510 2 1.10446 2.13014 7.5549 -9.15748 13.0523 1.42789 +511 1 0.330306 15.2957 6.90187 -7.34135 39.0889 57.248 +512 2 0.64916 14.9551 7.78023 -6.58887 6.78122 -17.5325 +513 2 0.549392 14.6745 6.26262 18.9985 -47.7984 -33.3782 +514 1 17.0475 6.9988 15.1595 3.61332 2.27156 3.35689 +515 2 17.7695 7.63103 15.0486 -1.58895 3.22527 -3.41358 +516 2 17.4554 6.32111 15.7084 -3.97121 -9.30147 -1.03946 +517 1 9.1229 12.4841 8.04245 42.4716 -17.0961 -6.2748 +518 2 9.3803 11.751 7.44403 8.89783 14.9312 6.88846 +519 2 8.20686 12.4452 7.97952 -55.5673 6.80073 1.54221 +520 1 1.25348 1.79037 2.92813 -6.45569 8.99744 5.64127 +521 2 0.618969 2.05555 2.26044 -0.811293 0.804254 -10.1384 +522 2 1.53437 2.62736 3.32834 8.32683 -8.65344 1.50874 +523 1 4.08283 15.132 9.84955 18.6585 -7.67887 -4.13383 +524 2 4.13303 15.3467 8.91064 -4.64689 1.73023 -5.13685 +525 2 4.95775 14.7288 10.0227 -10.2431 6.10486 1.39562 +526 1 7.30601 2.19422 14.6517 -6.95706 -8.0865 3.71032 +527 2 7.17746 1.61632 13.8834 -0.940722 6.01065 3.73041 +528 2 7.50104 3.06853 14.3169 9.18921 6.42869 -7.97623 +529 1 18.506 14.6308 2.17255 -30.1365 -0.614545 -1.61255 +530 2 0.727688 15.0378 2.26332 7.05 8.92743 1.17189 +531 2 17.7886 15.3173 2.20949 19.3309 -8.24877 -2.15246 +532 1 9.97566 2.72581 12.9114 -11.2099 12.673 12.9937 +533 2 9.86165 2.06107 12.2382 3.86591 -12.7401 -14.4562 +534 2 9.16654 3.26167 12.8314 9.11555 0.77907 4.27596 +535 1 2.93178 8.92582 13.081 1.70152 2.66119 1.53014 +536 2 3.14805 9.86555 12.9479 4.31652 -6.20308 -1.56758 +537 2 3.73073 8.51399 13.4597 -8.92719 0.122715 -5.32652 +538 1 3.2497 8.49808 3.73135 7.7637 26.6897 -66.399 +539 2 3.59457 9.35475 3.3251 -8.07179 -35.8245 7.88572 +540 2 3.32757 8.66083 4.63283 0.688531 4.50937 55.9505 +541 1 5.66796 7.21231 8.59238 -0.641232 -8.3741 -2.33168 +542 2 5.55885 6.25431 8.52804 10.6614 2.37054 -1.78385 +543 2 4.98671 7.4468 9.22816 0.961703 9.61661 1.51464 +544 1 14.8738 1.42122 1.93778 -12.939 -8.09002 14.9013 +545 2 14.5066 2.19936 2.41013 13.5309 -5.26917 -12.7438 +546 2 15.3961 1.64306 1.16722 2.80937 13.5796 -4.98575 +547 1 8.4154 15.1394 0.773463 -1.23857 3.93157 -9.75401 +548 2 9.15191 15.1483 1.39458 4.79594 -7.97678 6.77178 +549 2 7.72939 14.5584 1.13871 1.01453 -0.106788 3.48853 +550 1 15.5631 1.364 7.19799 20.5383 14.1474 18.9399 +551 2 14.9704 0.811359 6.72127 -20.082 -15.4085 -14.9718 +552 2 15.0111 2.04928 7.59859 -2.39038 6.78983 -5.63995 +553 1 5.04086 13.0229 18.4653 -16.526 -4.40388 -18.1368 +554 2 5.51186 13.0765 0.64315 8.46246 3.02378 17.117 +555 2 5.66208 13.3388 17.7987 -1.33855 -1.44241 4.73678 +556 1 15.3891 8.54048 18.1286 -6.10206 -9.0298 20.9903 +557 2 15.6702 9.06907 17.396 9.32842 15.5064 -17.6225 +558 2 15.3407 9.15597 0.239346 -3.25407 -2.5962 -5.00154 +559 1 12.0788 3.07289 18.3192 12.549 -10.6185 1.49283 +560 2 12.5729 2.60825 0.359083 -9.10594 9.02489 11.6275 +561 2 12.4194 2.60778 17.5512 -7.87867 2.96301 -9.52933 +562 1 13.1665 12.6793 5.14706 7.93439 -3.9476 12.1924 +563 2 13.7696 11.9755 4.86963 -4.91093 -2.83846 -5.3825 +564 2 13.2489 12.6724 6.11347 -1.2685 5.53825 -1.32442 +565 1 6.04116 7.20215 0.12064 7.04453 6.18255 -12.3628 +566 2 5.83851 8.12748 -0.154348 1.72696 -16.7644 14.2262 +567 2 5.20617 6.73813 0.252386 -0.898724 4.83199 2.26117 +568 1 17.6547 15.8889 14.9543 35.0528 -4.14946 21.8068 +569 2 16.7907 16.2722 15.0644 -14.9966 1.76464 -15.1201 +570 2 17.9353 15.7106 14.0428 -17.4402 7.26196 -6.43436 +571 1 13.1733 0.917277 16.6395 -12.3557 8.76343 2.76166 +572 2 14.0527 0.785776 16.9891 12.1183 -2.33791 -0.0845054 +573 2 12.8033 0.0287439 16.599 0.155899 -2.85039 -4.8341 +574 1 10.9713 14.5555 7.36537 -14.2255 -14.9035 9.86762 +575 2 10.1709 14.1495 7.79489 23.622 7.7433 -12.5051 +576 2 11.716 13.9517 7.54396 -5.74804 5.50666 -0.0050929 +577 1 17.5337 8.50243 2.08938 -5.40396 -31.7286 -5.54565 +578 2 16.6651 8.377 2.51924 11.1588 5.07358 -2.60802 +579 2 17.6234 7.66639 1.54889 -0.0314299 30.6214 9.39113 +580 1 12.3599 7.90174 1.98937 3.23567 -16.3128 -6.49447 +581 2 11.7961 8.65526 1.85661 -2.62113 17.411 2.96359 +582 2 12.056 7.28247 1.30894 3.22552 -0.339632 3.88847 +583 1 11.9987 14.6627 10.3756 12.942 21.9862 15.1728 +584 2 12.1481 13.8459 9.95801 9.02096 -31.6093 -18.7525 +585 2 11.0572 14.7574 10.3761 -24.4084 6.55121 -1.49817 +586 1 6.83545 6.97591 15.5496 -11.1581 -18.4558 -7.96595 +587 2 7.75433 6.91064 15.3306 20.697 -3.79434 -9.10488 +588 2 6.829 7.75126 16.0755 -7.29309 23.7102 19.2635 +589 1 8.01446 4.61093 13.3684 -42.1501 -10.3174 -21.1074 +590 2 7.18404 4.82769 12.8493 26.4504 -9.34552 12.0218 +591 2 8.34807 5.45326 13.6307 9.05324 16.4922 6.04122 +592 1 13.4266 12.1814 14.3212 -6.42777 -0.785601 -11.9683 +593 2 13.0158 11.3184 14.1828 2.17743 -6.12306 4.21948 +594 2 13.8675 12.3621 13.4761 -0.124998 4.48227 1.48561 +595 1 14.6825 9.43166 7.27492 9.85972 28.3832 27.9741 +596 2 15.5174 9.92891 7.46534 -14.0141 -13.1604 -8.13985 +597 2 14.0576 9.79435 7.94424 7.51867 -12.8522 -19.303 +598 1 12.7091 16.9592 3.18265 16.188 -54.3303 -7.24671 +599 2 12.7269 17.2341 4.07879 2.36138 14.6014 27.6129 +600 2 12.279 17.6213 2.6979 -21.2589 39.1636 -23.5451 +601 1 1.03636 7.13727 17.3765 4.75158 -4.20474 15.7377 +602 2 0.172257 7.41544 17.719 4.25282 -10.0113 -2.57097 +603 2 1.1139 7.5113 16.5007 -3.03142 8.85376 -8.54904 +604 1 12.882 5.00728 15.6915 -13.3168 2.35737 2.40623 +605 2 13.5933 4.38686 15.8029 14.6532 -13.0711 -0.480408 +606 2 13.3236 5.8608 15.7721 -0.35756 9.80313 -2.71263 +607 1 2.42233 3.36085 5.14652 -1.4819 -20.4954 -28.2661 +608 2 1.78479 3.2289 5.83557 -10.283 -5.3637 15.3955 +609 2 2.79623 4.21009 5.29825 15.429 26.5106 10.9541 +610 1 8.29403 11.1124 13.578 -10.7346 17.3121 -71.8204 +611 2 8.44225 10.8317 14.4188 2.94407 -17.9634 86.1576 +612 2 9.02074 10.6663 13.1421 6.44484 1.50589 -14.4967 +613 1 12.9406 1.47026 13.2897 0.354478 -37.8914 22.4103 +614 2 13.6523 1.40022 12.6671 11.2026 2.70228 -18.849 +615 2 12.6313 2.34545 13.2159 -11.96 35.388 -6.53093 +616 1 6.51021 13.5896 2.17003 14.8824 -7.80817 -21.2989 +617 2 5.87965 13.8406 2.83705 -10.6705 6.78718 16.3658 +618 2 7.14425 12.9838 2.58896 -6.69863 7.51381 1.45504 +619 1 15.9112 6.50963 12.6885 16.1371 8.47906 -9.98075 +620 2 16.4229 7.02402 12.0187 -10.4906 -13.771 14.0264 +621 2 16.4535 6.54884 13.5054 -11.4677 1.21509 -6.34034 +622 1 16.8027 0.705691 9.58115 1.1294 19.8318 -8.72086 +623 2 16.927 18.412 9.70296 -4.50862 -18.5326 4.35013 +624 2 16.4766 0.834017 8.66778 -1.09927 -3.21438 5.98018 +625 1 6.10776 11.6244 8.30817 -7.08025 31.3016 10.3571 +626 2 5.31117 11.3633 8.78813 -2.85933 -0.839224 -1.79107 +627 2 6.50869 10.8152 8.04097 10.2317 -24.1838 -9.43106 +628 1 2.82434 8.71866 0.367104 27.0695 8.27339 20.5452 +629 2 2.22535 8.20379 18.5266 -22.1964 -28.7808 -30.261 +630 2 2.24775 9.38106 0.731441 -2.19807 14.7641 10.188 +631 1 10.1092 10.4559 6.56308 -0.703462 -11.3062 5.02538 +632 2 10.4957 9.70218 7.03882 1.80116 3.11275 -0.176711 +633 2 10.5447 10.4553 5.70619 3.2422 0.610478 -8.25928 +634 1 6.77867 15.7679 6.62657 -1.68281 -11.8864 -9.65654 +635 2 7.19346 15.995 7.46341 4.74707 6.17504 0.549944 +636 2 7.26738 16.2069 5.90636 -4.84487 7.71134 8.89334 +637 1 6.4599 12.9833 5.69613 7.9309 12.6721 2.99822 +638 2 6.6611 13.9194 5.88765 -3.42976 -10.7335 1.27405 +639 2 6.10779 12.6203 6.51977 -0.735551 -2.83601 -1.42622 +640 1 16.7784 12.5316 9.7686 6.64513 16.9355 2.79564 +641 2 16.9553 11.9755 9.0112 -1.14761 -14.6768 -5.4217 +642 2 17.3143 13.3158 9.58219 -8.26404 -2.19889 6.01862 +643 1 6.14902 2.92407 2.76687 9.25618 8.55881 7.16487 +644 2 6.44579 3.84137 2.53376 -9.69316 -20.3131 -2.03165 +645 2 5.73381 2.47389 2.01355 1.00911 7.28801 -3.60537 +646 1 10.8507 3.14979 3.2526 -8.20022 -5.11042 -1.435 +647 2 10.2526 3.87795 3.44424 2.28516 4.24005 3.08111 +648 2 10.4324 2.67577 2.52169 3.50832 1.84172 1.62718 +ITEM: TIMESTEP +60 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.82699 6.8727 17.8888 7.11742 1.34647 0.262135 +2 2 7.99 7.13914 18.2565 -12.0864 4.19935 8.4109 +3 2 8.62901 6.07007 17.4227 -0.244169 -11.025 -10.1388 +4 1 18.7394 8.29949 6.7561 2.34576 -2.93089 -42.9257 +5 2 0.440553 7.9626 5.87052 -19.1153 18.5732 27.9896 +6 2 0.571955 7.78688 7.39134 9.59653 -12.4008 18.4821 +7 1 8.51178 18.783 6.87295 -6.05415 -5.58023 12.25 +8 2 9.39304 0.279078 6.53812 12.1519 1.3365 -4.9205 +9 2 7.9628 0.741428 6.37316 -1.87647 6.654 -3.74148 +10 1 6.53357 1.7197 11.6944 -32.7429 -8.61455 3.24653 +11 2 5.73579 2.18358 12.0739 27.4882 -10.0969 -10.5409 +12 2 6.18445 0.855878 11.3477 8.95005 26.2974 10.8481 +13 1 6.96535 5.62987 2.3961 35.6431 -32.0928 -15.0783 +14 2 6.38293 5.93218 3.05619 -24.6612 16.4463 30.6134 +15 2 6.84916 6.21974 1.66578 -5.97717 13.8881 -18.7681 +16 1 16.1974 10.2298 16.1222 0.837184 6.4903 1.28091 +17 2 17.0743 10.6189 16.0747 2.49014 -9.13099 -5.48379 +18 2 15.6463 11.0038 16.2733 -2.87215 -2.05097 1.79245 +19 1 10.6702 14.9469 2.31164 21.9083 12.0632 13.3283 +20 2 10.6818 14.2862 3.02723 -4.43621 6.7471 -1.73288 +21 2 11.263 15.6645 2.64965 -13.2726 -10.9824 -6.65814 +22 1 17.1701 8.22403 10.7142 -10.4028 1.03109 3.96163 +23 2 16.5672 8.79102 11.2349 7.05768 -1.94337 -2.70487 +24 2 17.9333 8.77716 10.499 4.44622 1.4788 -2.07857 +25 1 14.6797 15.9035 16.4693 -22.461 3.39408 -16.7947 +26 2 13.7484 16.2021 16.2951 24.3498 -9.2952 11.1 +27 2 14.6463 15.3225 17.2482 2.4047 10.3841 -3.14234 +28 1 12.1037 13.3669 0.54665 -3.27844 11.868 -6.89748 +29 2 11.8248 13.5865 18.2899 5.63772 -9.83511 -2.25753 +30 2 11.6388 14.0254 1.08354 0.310925 -7.08728 5.11983 +31 1 9.3344 5.48343 3.92748 33.8763 5.32583 -18.4372 +32 2 8.84687 5.22044 4.68611 -23.4915 -4.94858 24.7343 +33 2 8.7079 5.56619 3.20676 -14.265 -0.820383 -3.61874 +34 1 1.71101 4.06482 11.6122 14.6912 -29.1046 6.03323 +35 2 1.58258 4.96723 11.8918 -1.25551 20.6962 3.43651 +36 2 2.34968 3.65386 12.2459 -15.6865 7.58906 -11.285 +37 1 2.0576 6.82445 8.24528 12.7796 11.6573 13.2587 +38 2 2.61911 7.2356 8.94539 -14.081 -6.70064 -12.0447 +39 2 1.89349 5.9205 8.55263 1.83531 2.80349 -1.77694 +40 1 5.39864 4.45401 7.95786 1.68333 5.33174 7.59028 +41 2 5.55249 3.50745 7.87389 -3.64833 -7.88894 -5.24716 +42 2 4.83854 4.74959 7.2381 -8.525 -1.92619 -10.156 +43 1 3.30216 2.93412 17.4505 12.3495 -29.8256 -18.8762 +44 2 3.92727 3.3713 16.8479 -0.637689 -1.64749 6.41076 +45 2 2.89532 3.6118 17.959 -11.8167 26.1488 16.8317 +46 1 7.4312 5.4352 6.15055 3.3909 -0.433751 -53.1737 +47 2 7.92374 5.97877 6.73644 15.9967 14.3411 25.9486 +48 2 6.95714 4.77392 6.61797 -10.969 -14.5624 25.0012 +49 1 9.79304 6.98632 12.0044 -11.2776 3.50532 -30.3595 +50 2 10.3262 6.37648 11.4616 -6.26095 5.52929 9.55968 +51 2 9.10346 7.3395 11.3719 14.604 -9.64535 21.0978 +52 1 14.0819 3.68689 8.0984 5.37498 8.43639 24.1843 +53 2 13.9041 4.52495 7.65095 -1.63712 -2.30615 -0.914734 +54 2 14.2511 3.92795 9.04472 -1.39906 -3.736 -24.3353 +55 1 4.49163 17.2405 3.95076 10.4122 -13.5126 12.545 +56 2 5.41424 17.4498 3.85674 17.5711 4.37719 2.71306 +57 2 4.10795 17.4238 3.10711 -15.6864 12.0721 -17.6618 +58 1 16.4063 16.5742 10.3304 -30.4876 -1.09383 10.2792 +59 2 15.5552 16.587 10.8552 23.7267 -0.690427 -17.666 +60 2 16.1781 16.1401 9.48726 -2.06021 -0.342568 9.10707 +61 1 2.01216 4.81629 0.267482 -15.744 -7.33716 -25.0709 +62 2 2.32092 5.21812 1.07081 12.8803 9.20197 12.7852 +63 2 1.84588 5.54667 -0.35429 -3.07657 2.24499 6.46529 +64 1 11.4525 13.2643 16.3577 0.360612 25.402 13.2121 +65 2 11.0472 12.4174 16.5451 -7.76012 -9.6277 -2.94397 +66 2 11.9986 13.1376 15.5855 6.89063 -5.57893 -10.2697 +67 1 10.1527 10.9848 16.8633 -20.103 19.6526 2.73515 +68 2 10.5885 10.1542 16.8545 15.6291 -29.738 -2.50548 +69 2 9.22545 10.7635 16.7018 -0.592014 4.00252 0.856412 +70 1 11.7907 17.4531 13.47 6.77179 16.9038 -5.30963 +71 2 12.2429 16.8403 12.875 5.23267 3.61287 1.34276 +72 2 12.1771 18.3441 13.2664 -10.6628 -13.9509 7.62196 +73 1 6.44648 9.35189 12.2088 11.1766 16.4313 12.1054 +74 2 7.06476 9.1188 11.5034 -9.94127 -5.08631 1.40965 +75 2 6.99588 9.90362 12.7958 -7.62877 -4.94562 -4.27954 +76 1 16.2706 12.8594 2.68209 -1.75731 9.60563 4.91889 +77 2 17.1141 13.3556 2.57766 -16.4869 -7.21292 0.814827 +78 2 15.5397 13.5204 2.75856 19.4288 -8.85346 -2.79343 +79 1 0.706006 12.6575 5.91598 14.3848 1.31093 7.35726 +80 2 1.05127 12.3982 5.06653 10.4666 0.953953 -14.2919 +81 2 18.4268 12.7017 5.73438 -31.2224 -1.2993 2.30782 +82 1 5.26466 16.4058 18.4218 -16.1073 15.9927 3.08559 +83 2 5.67174 15.6665 17.9813 11.5666 -13.4602 -0.82172 +84 2 5.61268 16.4896 0.669718 7.09967 -3.66518 0.290508 +85 1 0.630514 7.71832 4.14439 -40.0144 -22.0429 16.8318 +86 2 18.6762 8.08291 3.48621 -5.56982 2.47832 -6.04635 +87 2 1.47362 7.93412 3.82987 48.6931 13.8203 -16.755 +88 1 3.15187 8.95984 6.48267 23.8542 8.38798 -14.0929 +89 2 3.71388 8.45844 7.06344 9.53544 -4.30832 6.22463 +90 2 2.31458 8.97258 6.8974 -32.9047 0.579586 11.7619 +91 1 7.26503 10.3427 16.2788 17.1997 0.0580756 -23.1821 +92 2 6.56569 10.7121 15.7432 -4.58149 2.66195 0.233626 +93 2 6.94547 10.3415 17.17 -9.40627 -4.59594 18.3856 +94 1 11.082 0.946861 5.00581 6.19269 9.74659 5.8053 +95 2 11.2852 1.82567 4.65658 -6.55006 -0.520752 -0.877191 +96 2 10.8571 0.430046 4.22808 -5.9868 -5.86677 -2.53499 +97 1 4.345 2.8292 13.2132 -1.27186 28.7368 -8.62995 +98 2 4.51529 3.21096 14.0791 1.17168 5.0352 0.572822 +99 2 4.2316 1.91147 13.3845 -6.13817 -32.6591 5.85186 +100 1 8.38376 10.2307 1.79685 4.09005 3.74222 -19.3624 +101 2 8.31491 10.9253 2.45197 -4.24337 3.92137 10.2746 +102 2 8.66929 9.45546 2.26885 2.27917 -12.8064 10.4703 +103 1 10.3305 1.70894 15.5022 6.01592 -1.55552 8.18831 +104 2 11.2875 1.57757 15.6324 -10.5356 -0.805047 -6.9053 +105 2 10.1546 1.87921 14.5629 5.4285 2.19916 1.25738 +106 1 2.65797 12.824 7.8537 2.67737 0.310449 -2.88199 +107 2 3.19441 13.4775 7.37699 -0.834696 -1.21778 5.43137 +108 2 1.94106 12.6113 7.24505 -1.36647 0.43678 -0.0339739 +109 1 3.78494 11.7026 5.05983 17.7759 13.7966 10.32 +110 2 3.63161 10.9725 5.64962 -3.29006 -9.81966 6.20688 +111 2 3.00915 11.823 4.52928 -13.3129 -0.91097 -10.8894 +112 1 6.77794 14.436 16.9596 -4.81268 9.99067 -5.99614 +113 2 7.54793 15.0018 17.1111 -0.926912 -4.93073 -4.17577 +114 2 6.38498 14.6674 16.0968 9.73202 -0.180074 3.30595 +115 1 14.2221 14.5157 3.27778 -13.9298 6.06594 9.9851 +116 2 13.8151 15.3779 3.06073 2.11094 -9.8452 8.88116 +117 2 13.8089 14.1856 4.11 4.80477 6.02161 -17.3229 +118 1 8.54544 18.1123 16.0497 -51.2002 16.193 -5.03192 +119 2 8.97127 17.2819 16.1484 30.3531 -21.0569 10.3371 +120 2 9.10378 0.243275 16.0887 21.8256 4.58901 -4.15396 +121 1 4.6724 1.65079 4.89395 -0.428695 -35.2982 26.3678 +122 2 3.9342 2.19791 5.10489 -21.2256 11.2309 2.3914 +123 2 5.17375 2.14476 4.28849 23.1392 22.1006 -30.0951 +124 1 14.9936 12.6291 16.4673 -19.77 11.4375 -24.1827 +125 2 14.4795 13.0601 17.1383 2.64859 2.32978 20.7439 +126 2 14.3496 12.6271 15.7247 18.4778 -8.83273 3.74622 +127 1 15.7172 18.4491 16.8771 -38.7365 1.31848 -37.9731 +128 2 16.4119 18.3751 17.4758 43.0193 1.36234 40.9307 +129 2 15.3332 17.5625 16.8778 1.44654 -2.1141 -5.88546 +130 1 1.31769 1.23679 16.6144 -6.54563 -5.62507 -9.64947 +131 2 2.12749 1.70533 16.7963 11.1847 9.69542 4.67012 +132 2 0.698368 1.60678 17.2434 -6.22801 1.29783 7.94738 +133 1 18.1828 4.42633 15.9571 -10.2445 4.38521 4.02875 +134 2 18.0727 3.95797 15.1342 -1.32851 -5.12675 -7.69371 +135 2 0.442412 4.30859 16.2307 9.57607 0.794437 2.0974 +136 1 12.2114 16.9885 16.1505 19.3184 14.9656 -43.0527 +137 2 11.4192 16.582 16.4369 -30.1172 -13.2398 21.5491 +138 2 12.0643 17.0779 15.1772 3.25614 1.68146 17.8786 +139 1 16.0795 2.58494 18.1555 11.3664 -10.2705 19.274 +140 2 15.8693 3.49863 18.3 -12.3112 17.2654 5.58069 +141 2 15.8977 2.41247 17.2454 -5.4363 -1.34473 -24.067 +142 1 6.67972 13.8354 10.1508 -8.25744 -4.72138 -13.3408 +143 2 6.54568 13.5231 11.0561 -0.87434 -6.75398 -1.82198 +144 2 6.44555 13.1152 9.51962 7.50297 7.52708 13.7797 +145 1 10.1393 18.4632 2.72581 -2.6903 -13.3312 7.25948 +146 2 10.3702 0.440572 2.04373 3.08075 7.1003 -10.4416 +147 2 9.34905 18.0295 2.38643 -2.95732 2.6687 3.95308 +148 1 3.05039 17.7207 6.12428 0.448774 -3.44066 -6.39261 +149 2 2.22716 17.4884 5.64326 9.1847 7.623 2.40325 +150 2 3.74061 17.8548 5.44564 -15.5509 -1.85687 4.81473 +151 1 12.5974 16.8374 7.98109 22.5462 3.91689 -18.138 +152 2 11.9813 16.1063 7.98041 -18.255 -3.99171 0.854341 +153 2 12.4106 17.4726 8.66951 -8.78709 2.06599 13.7307 +154 1 14.8906 15.2874 8.20197 12.2291 6.1037 -1.40009 +155 2 14.0169 15.6824 8.32954 6.14586 6.92547 -6.68196 +156 2 15.3058 15.6925 7.40177 -13.6896 -13.6819 15.1947 +157 1 17.774 18.2462 0.317021 16.5526 -0.292921 -8.65749 +158 2 18.517 17.6459 0.018512 -14.2865 26.6269 11.4024 +159 2 18.1212 0.514643 0.485201 -2.53379 -23.9559 -4.59837 +160 1 0.824062 10.4854 1.38532 29.0751 41.1299 -24.8426 +161 2 0.152225 9.85957 1.54468 -35.7643 -25.6114 8.77961 +162 2 0.463481 11.18 0.764874 10.1431 -20.9883 20.7352 +163 1 1.76832 12.2434 3.3342 -0.376699 -6.62105 -8.54196 +164 2 1.60728 11.5206 2.66813 -0.613387 21.7926 10.4725 +165 2 1.98383 13.0773 2.86566 -4.64348 -14.8628 -2.7215 +166 1 0.631416 17.2455 4.93339 -1.94983 -6.83399 6.66588 +167 2 18.8682 18.1422 4.98859 -2.83763 -23.6492 7.38562 +168 2 0.299607 16.5671 5.5918 8.11627 31.0276 -16.6779 +169 1 1.13057 0.905706 9.36586 -12.3827 -0.18715 22.5068 +170 2 1.31261 0.747855 10.3312 -4.25497 -2.51626 -23.3877 +171 2 0.268645 0.477115 9.21068 10.8181 5.54227 0.850191 +172 1 16.7346 2.37332 13.3038 3.72479 1.84576 21.5886 +173 2 16.9761 2.56684 12.4028 0.0757035 3.67621 -15.1405 +174 2 16.5678 1.42686 13.3713 -2.69734 -3.58003 -5.961 +175 1 2.71222 15.8556 12.0453 -23.2953 18.5694 10.7935 +176 2 3.02055 15.4773 12.8617 6.20357 -6.16654 7.20198 +177 2 3.26455 15.5565 11.3309 7.18341 -3.43964 -7.05157 +178 1 16.426 15.6488 6.1101 -14.7609 -25.4644 9.17481 +179 2 17.2826 15.6571 6.51544 16.1879 -4.44611 5.83009 +180 2 16.438 16.358 5.49538 -5.11113 23.225 -23.4349 +181 1 5.76882 5.13637 11.8122 -12.0704 17.5482 5.11471 +182 2 5.44081 5.9885 12.2003 4.95719 -19.5528 -5.70673 +183 2 5.01212 4.52871 11.8104 6.55972 2.89024 2.61392 +184 1 15.1343 4.86498 0.81249 17.6468 10.3526 -37.7608 +185 2 14.8624 4.60472 1.67155 -6.094 -8.43385 31.413 +186 2 14.42 5.38891 0.454388 -5.76674 3.16257 -0.979918 +187 1 16.354 16.4047 2.01729 -13.9507 10.6217 3.88258 +188 2 15.8491 16.8174 2.76015 19.926 -7.04016 -11.695 +189 2 16.7635 17.1307 1.5183 -3.64457 0.258913 2.52225 +190 1 0.229093 4.84171 3.85636 -16.5361 -39.1535 -9.01102 +191 2 0.280674 5.76384 3.97165 5.27146 43.6678 4.59383 +192 2 0.903367 4.46589 4.41298 10.8 -4.72049 2.86342 +193 1 2.98031 15.0696 15.1724 7.38994 17.2595 -26.1187 +194 2 2.78389 14.6733 16.0132 -4.59533 -4.91572 22.4357 +195 2 2.69496 16.0061 15.2442 -6.09825 -12.2809 0.399162 +196 1 1.14224 14.6486 9.53301 9.69931 -12.3423 3.57818 +197 2 2.08157 14.8372 9.66442 -5.69448 4.03807 -1.75917 +198 2 1.10168 13.6946 9.72739 -6.61933 10.5759 -2.74939 +199 1 13.5148 16.5367 11.5259 11.0739 -5.14125 9.92262 +200 2 13.0998 17.2443 11.0437 -3.0151 15.655 -8.61356 +201 2 13.0781 15.7617 11.1648 3.09342 -5.90037 -0.559148 +202 1 4.6468 1.4492 0.760442 21.9419 17.6404 -6.63386 +203 2 4.03376 2.00221 0.272437 -3.30289 2.18566 -6.21296 +204 2 4.11186 0.849122 1.26962 -7.6403 -10.762 3.4591 +205 1 1.46385 18.5705 11.8684 11.5971 1.37494 19.5738 +206 2 1.40443 0.572196 12.6059 -0.800227 -11.3118 -6.50307 +207 2 2.03902 17.8403 12.1929 -11.6325 11.1906 -9.16825 +208 1 11.4878 10.1514 4.00495 -23.562 -17.5625 40.225 +209 2 11.4445 10.4449 3.12053 -0.0273244 15.9845 -32.1431 +210 2 12.4087 10.0544 4.20335 22.0666 -0.101113 3.57488 +211 1 8.17978 12.1587 3.71493 28.653 -3.15285 -17.361 +212 2 9.01377 12.5671 3.97927 5.41625 0.887106 1.05136 +213 2 7.604 12.3558 4.43149 -23.5411 2.07968 29.6007 +214 1 14.5452 4.04195 3.30356 -17.0528 -5.31405 -8.64237 +215 2 15.1661 4.06926 4.02931 6.41379 4.8272 12.7333 +216 2 13.7233 4.44982 3.62226 2.87412 -0.159853 0.628569 +217 1 5.66111 1.64664 7.53337 47.3068 24.6854 -47.7691 +218 2 4.99385 1.2169 7.99076 -47.8059 -33.9417 34.4755 +219 2 5.55481 1.33937 6.59792 -2.0798 14.2024 17.8553 +220 1 17.8737 1.09537 4.84004 -13.6202 -14.1831 4.02096 +221 2 18.464 1.49436 4.20233 9.91759 7.15437 -5.32228 +222 2 17.8561 1.60546 5.65338 7.58498 6.35358 2.28946 +223 1 6.84561 9.39092 4.51119 3.77645 -4.79561 13.9854 +224 2 6.80242 9.62767 5.4641 3.30223 -6.77647 -16.668 +225 2 7.74702 9.0401 4.34673 -10.1352 5.61637 3.28246 +226 1 2.64818 14.8733 2.0031 -12.6643 -4.21043 8.13073 +227 2 3.39044 14.7832 2.61388 1.60205 1.10943 -1.58393 +228 2 2.93662 15.3311 1.21566 8.61024 -0.712779 -4.79925 +229 1 17.3356 12.9304 13.2091 0.397713 16.5012 -11.0143 +230 2 16.4513 13.2838 13.3976 5.15185 -2.46087 0.53778 +231 2 17.8465 13.7314 12.9621 -7.21788 -13.1567 2.02539 +232 1 14.9178 10.5628 1.45295 0.32879 33.5889 18.189 +233 2 15.3786 11.3985 1.79277 -12.1624 -32.8958 -12.3175 +234 2 13.9692 10.6935 1.62732 12.9477 -1.40805 -3.43718 +235 1 5.70482 6.69167 4.56094 -12.9541 28.0444 -8.31435 +236 2 5.76223 7.67071 4.46331 5.24004 -15.8993 1.97075 +237 2 6.3673 6.43877 5.21208 3.70858 -3.97365 0.601716 +238 1 7.97185 8.33683 10.3069 8.6941 -15.2025 -3.68424 +239 2 8.60404 8.92215 9.84221 -9.13329 -6.11086 -5.89913 +240 2 7.51742 7.70171 9.70626 6.59476 18.8917 -0.227694 +241 1 13.4177 18.464 5.71198 21.9916 6.6123 -14.6219 +242 2 12.6947 0.421284 5.51228 -9.11836 -2.12279 2.23123 +243 2 13.1839 18.0173 6.51737 -9.90438 -14.4062 13.6987 +244 1 0.0221035 2.62655 0.261444 12.6472 -47.1951 11.8456 +245 2 17.7527 2.75577 18.6598 -10.3686 10.7513 -7.61459 +246 2 0.546882 3.40438 0.188377 7.87852 33.0005 -3.15527 +247 1 12.8067 10.9927 9.75832 44.9647 -24.4125 8.46131 +248 2 11.8751 10.9314 9.65932 -31.4773 -7.30673 -3.09024 +249 2 13.1121 10.0761 10.034 -17.0663 24.2241 -8.13324 +250 1 0.673563 12.1459 11.0385 -14.9158 10.2345 17.3916 +251 2 18.3756 12.1565 11.2954 6.68564 0.0119082 -11.299 +252 2 1.10384 12.3853 11.8646 9.18612 4.40652 0.693569 +253 1 5.14721 7.33361 13.3929 15.7357 3.63047 1.84442 +254 2 5.59488 8.13358 13.0475 0.482915 -12.4288 -2.35902 +255 2 5.71887 7.03407 14.1269 -8.93121 6.52874 -3.37327 +256 1 1.18567 6.84505 11.8697 14.6786 34.5125 12.17 +257 2 0.393465 7.21987 11.4553 4.74321 -4.21777 2.31791 +258 2 1.70022 7.64215 12.2222 -16.972 -31.3024 -13.5319 +259 1 15.4816 9.69158 12.3277 9.90347 -39.8653 -1.57959 +260 2 15.3406 10.5924 12.1653 -13.2531 41.4735 -11.5871 +261 2 15.406 9.62533 13.2698 1.46249 -6.23285 16.1579 +262 1 16.5413 12.6347 5.5059 7.75274 -6.4804 14.118 +263 2 16.3104 13.5445 5.70094 -2.97213 12.2972 0.10227 +264 2 16.3923 12.5258 4.56955 -2.98329 -0.0504447 -18.3871 +265 1 6.30461 9.82716 0.0624729 6.72618 23.4574 16.6882 +266 2 5.51437 10.3287 0.304315 -0.069722 -0.440899 2.51054 +267 2 6.96842 10.0501 0.765687 -11.6212 -9.0506 -14.676 +268 1 12.2588 6.10042 4.03099 15.0483 24.7381 -3.94445 +269 2 12.3021 6.98896 3.58767 -5.34003 -28.327 1.95056 +270 2 11.3325 5.86569 4.06669 -11.2394 -4.89225 -2.88949 +271 1 0.336489 12.822 0.136131 -4.0328 -4.68121 -1.73262 +272 2 -0.0692718 13.3776 0.815875 4.64589 5.49593 0.971726 +273 2 18.45 12.9344 17.9884 -7.92492 5.13291 -5.47118 +274 1 3.58866 18.6351 8.62238 -6.65617 9.61834 5.79691 +275 2 3.41901 18.3768 7.70859 0.297411 -7.32139 -0.213682 +276 2 2.71275 0.31261 8.92207 15.7588 -5.16119 -5.17535 +277 1 7.50496 17.418 4.49772 -12.5742 -28.6928 8.65377 +278 2 7.55283 18.3491 4.58726 6.16277 33.1384 2.27358 +279 2 7.74423 17.2559 3.59134 -1.33953 -2.22923 -11.883 +280 1 9.26392 17.1331 12.2129 -23.7136 4.99112 -6.35848 +281 2 9.34774 16.2465 11.866 0.0093118 -9.2577 -7.50778 +282 2 9.98892 17.2487 12.8038 23.7327 3.38143 15.862 +283 1 13.3751 13.0337 7.97577 10.7478 10.6887 -13.5108 +284 2 13.3787 12.2298 8.50206 6.89696 -2.46192 7.10708 +285 2 14.2592 13.4885 8.01338 -22.4634 -9.00878 7.77512 +286 1 14.8592 2.99547 15.3735 -5.27851 1.66435 23.9116 +287 2 14.1885 2.32373 15.2402 -1.63897 -5.65445 -5.41614 +288 2 15.4149 3.00295 14.6023 9.16888 -1.78425 -15.607 +289 1 9.86925 15.6154 16.9672 4.33331 -1.89849 4.26663 +290 2 10.4152 14.8537 16.7052 -6.80597 -3.90746 -0.277805 +291 2 9.57771 15.4416 17.8827 0.419377 0.378738 -9.64067 +292 1 11.2678 8.44973 16.5939 -8.08747 -14.0791 2.0813 +293 2 10.6693 7.85604 16.0792 7.94549 12.4538 10.9378 +294 2 11.4172 8.01973 17.4598 -1.80582 0.647834 -14.6449 +295 1 3.91551 18.1683 16.8005 9.39931 12.2215 14.3903 +296 2 4.49606 17.6509 17.3756 -3.52447 -10.1131 -6.81095 +297 2 3.95318 0.38369 17.2365 -5.94998 0.470214 -7.14863 +298 1 2.19966 4.20574 8.91394 -16.952 6.25086 -28.7566 +299 2 3.11163 4.1112 8.67966 19.1354 -3.54458 -0.459765 +300 2 2.10589 3.95692 9.81579 -0.00585893 -3.49833 31.5267 +301 1 9.86514 10.3731 9.72031 15.6542 -41.5135 2.74879 +302 2 9.61489 11.2182 9.40808 -14.4527 35.546 -8.7168 +303 2 10.0569 10.3888 10.6595 -0.965326 6.48855 10.4451 +304 1 9.65603 0.92083 10.8651 15.4128 -5.93628 -1.69563 +305 2 9.35399 0.0448876 11.1808 -6.92756 10.8331 -8.061 +306 2 9.08478 1.27687 10.159 0.925367 -10.2687 5.27886 +307 1 9.17601 15.08 10.2001 28.4704 15.1584 7.58672 +308 2 8.86011 15.9493 9.94215 -4.94078 5.46469 -8.90142 +309 2 8.40516 14.5378 10.1682 -22.1716 -15.7686 -1.61012 +310 1 0.908908 9.65777 10.2661 1.02783 -39.6886 -13.0526 +311 2 0.968686 10.5462 10.5861 7.37828 17.5094 1.10535 +312 2 1.79128 9.34954 9.98968 -11.6106 9.29057 7.26807 +313 1 16.9796 4.82858 8.10785 29.2892 -10.1291 -25.9715 +314 2 16.4029 5.49318 8.42182 -23.755 22.5857 11.698 +315 2 16.8784 4.07707 8.6652 -3.89501 -13.8815 13.5617 +316 1 14.7893 14.6979 0.173135 5.39554 -7.96858 -12.7144 +317 2 15.0505 15.3823 0.785417 9.36392 5.93735 12.263 +318 2 13.9789 14.3219 0.494521 -15.109 -8.03615 11.244 +319 1 3.74323 11.0124 9.54886 4.38849 -4.14114 10.1409 +320 2 3.63158 11.395 10.4392 1.27308 -1.67175 -3.21468 +321 2 3.24423 11.5652 8.93525 -2.74645 9.31742 -2.2917 +322 1 11.2573 10.7534 1.46897 -2.74628 -20.4518 -2.00657 +323 2 11.6064 11.5358 1.05536 3.45865 20.4344 -8.16659 +324 2 10.3358 10.6724 1.18755 -1.77969 3.26872 -0.743535 +325 1 13.1779 7.19199 12.7182 14.2184 -9.05364 3.75753 +326 2 14.115 6.87295 12.7816 -17.4164 8.42328 -3.38551 +327 2 12.6212 6.40428 12.8017 3.66516 -2.90974 1.8722 +328 1 9.6094 1.86333 0.961036 -1.66559 10.1622 -20.0065 +329 2 8.74982 1.7634 0.476399 21.9169 -1.84649 8.18396 +330 2 10.2659 2.29351 0.366445 -15.6421 -6.48907 5.12748 +331 1 10.6591 13.4925 4.58018 -19.1141 -0.630091 -16.1529 +332 2 11.5305 13.1262 4.70232 12.5696 -8.82773 5.21944 +333 2 10.586 14.1761 5.24203 -0.728557 4.94256 14.6221 +334 1 14.495 1.73909 10.9749 -8.14936 -7.82556 -5.33359 +335 2 15.2253 1.30703 10.5146 2.44721 2.03735 2.44955 +336 2 14.6402 2.68373 10.8341 0.821335 1.15578 7.11863 +337 1 14.5247 12.1307 11.6327 6.29346 4.76638 51.459 +338 2 15.3146 12.4097 11.1999 18.4985 9.73575 -23.8815 +339 2 13.8662 11.9319 10.9987 -20.1843 -8.01501 -29.1382 +340 1 8.1934 5.08514 9.85848 20.6286 -7.50881 -18.2265 +341 2 7.39102 5.12991 10.3666 -14.5844 -3.05188 8.40055 +342 2 8.26178 4.1705 9.49849 -5.86813 14.6103 10.9415 +343 1 1.56363 16.9354 18.4208 -1.17306 -23.9048 5.52961 +344 2 2.13897 17.2639 17.7268 3.56106 5.06395 -9.30964 +345 2 1.54669 15.9596 18.2963 3.84009 16.9778 0.440392 +346 1 1.49268 17.3196 15.3241 -27.5122 8.95969 8.58328 +347 2 1.46041 18.2525 15.6844 -4.86102 -31.3543 -7.55486 +348 2 0.570896 16.9106 15.346 29.8648 20.9529 0.539048 +349 1 3.59911 5.78915 6.06648 9.03859 -15.9659 -5.84137 +350 2 3.1214 6.40715 6.60976 -11.746 7.94276 10.4286 +351 2 4.15987 6.31414 5.47841 1.03618 -2.86439 -0.897012 +352 1 12.5136 9.4824 14.2234 -14.5482 39.9006 11.9441 +353 2 12.9252 8.74241 13.842 20.5687 -36.5434 -22.703 +354 2 12.2915 9.17254 15.1019 -4.72781 -1.84288 9.93497 +355 1 4.05984 15.2792 6.9471 -25.1121 -18.1042 13.4141 +356 2 3.54373 16.0393 6.6659 -0.213909 7.77754 -0.115815 +357 2 4.94872 15.4739 6.70425 29.3053 8.29501 -4.075 +358 1 0.70733 8.67925 15.049 -6.53077 -6.52645 2.33041 +359 2 0.403057 9.59211 15.0995 2.0449 7.24241 -1.44461 +360 2 1.39578 8.67212 14.3782 6.73055 2.7204 -4.7895 +361 1 12.9505 8.27543 10.2426 2.52256 -9.36522 19.2887 +362 2 13.7222 7.81068 9.89429 1.56507 0.683648 -5.24915 +363 2 12.8789 7.88642 11.1491 -0.00217653 14.5673 -16.6218 +364 1 15.3477 7.80216 3.55401 -12.532 5.83489 -12.7989 +365 2 14.4906 7.48222 3.33103 -16.8871 -2.65253 -29.4538 +366 2 15.2947 7.61797 4.46883 25.5814 -3.41235 36.6493 +367 1 17.266 6.70187 0.000674068 12.1195 -8.95496 8.26487 +368 2 16.7457 6.00049 0.395257 -2.87342 -9.15243 0.336143 +369 2 16.622 7.35704 18.4101 -17.4752 15.3525 -8.08793 +370 1 8.88335 6.95399 7.81342 26.8473 24.5973 -5.8387 +371 2 9.80542 7.33522 7.87938 -25.1058 -10.3372 -2.45861 +372 2 8.7714 6.40725 8.58367 -2.11125 -14.3958 16.4377 +373 1 12.3879 0.548843 1.24082 4.42765 -0.472301 -1.45686 +374 2 13.3265 0.730859 1.40339 -2.38609 2.78881 -0.689397 +375 2 12.2563 0.636326 0.292606 2.56041 -5.4085 -0.678049 +376 1 5.63248 15.1125 14.5468 -9.48886 -16.8407 5.02155 +377 2 4.69503 15.2624 14.7723 5.83199 -5.28539 -1.87026 +378 2 5.99589 15.9615 14.314 8.44734 16.7096 -6.42729 +379 1 3.85575 6.39433 1.75493 1.50274 -8.79363 8.51258 +380 2 3.48975 7.20754 1.41538 -8.87879 17.021 -2.96274 +381 2 4.03803 6.55873 2.69128 -1.36395 1.28851 -4.88856 +382 1 3.93631 11.5299 12.3893 -8.10483 -0.317118 -5.66906 +383 2 4.80663 11.9435 12.4577 -3.51298 -1.2689 0.972005 +384 2 3.32279 12.1457 12.8171 1.30391 -5.08042 -1.13556 +385 1 5.30379 3.85961 15.861 3.26535 -66.7729 -21.4105 +386 2 5.99128 3.21668 15.5051 -18.0074 17.9789 14.3955 +387 2 5.71814 4.68422 15.8683 22.7973 48.3912 1.26107 +388 1 14.279 10.1761 4.52146 -28.2637 29.6843 37.5781 +389 2 14.4726 9.82647 5.40905 -2.50301 -0.0307068 -4.88302 +390 2 14.7482 9.65242 3.92054 26.3189 -27.9191 -30.9088 +391 1 7.73542 17.3919 9.15036 20.9187 -26.1564 3.32362 +392 2 6.89787 17.6412 9.51878 -14.391 11.6651 3.78997 +393 2 7.98556 17.9488 8.40931 -4.18052 11.5531 -5.69175 +394 1 4.50439 14.5239 3.99264 11.0977 -23.3764 -48.4991 +395 2 4.56306 15.4325 4.20277 -1.38797 35.5351 15.6514 +396 2 4.31322 14.0314 4.76491 -6.35847 -16.1784 30.998 +397 1 14.1606 7.45193 15.811 -24.1382 -9.56247 -10.586 +398 2 15.0553 7.36431 15.524 24.9604 -3.00047 -8.7167 +399 2 14.2305 7.91189 16.6334 1.28104 8.01927 19.5585 +400 1 2.99693 18.3516 1.90386 -17.8633 -43.3253 -26.4279 +401 2 2.47403 17.7132 1.31624 19.6124 26.5697 18.0429 +402 2 2.33007 0.205152 2.36966 -11.145 11.7012 10.1025 +403 1 8.00896 1.59538 4.54643 -14.6935 -3.1209 6.18761 +404 2 7.42733 1.99671 3.8763 8.34922 -0.442348 -1.34208 +405 2 8.90764 1.54031 4.21745 2.64121 3.0498 -7.75206 +406 1 2.41984 14.15 17.6911 38.7391 17.8224 -8.42313 +407 2 1.65201 13.6768 17.9262 -26.9962 -21.4224 14.4939 +408 2 3.15619 13.6354 18.0755 -0.305296 5.75785 -2.4818 +409 1 0.881322 1.80893 13.8899 -12.9164 4.63859 7.1799 +410 2 0.998981 1.67187 14.8549 -5.47541 -0.367675 -15.7697 +411 2 18.568 1.96442 13.7158 18.7475 -1.65173 8.16576 +412 1 4.35626 0.108756 13.8915 -10.9503 4.16473 7.68997 +413 2 5.20313 18.36 13.6952 15.0207 -4.30703 2.98167 +414 2 4.18562 18.5651 14.8318 -0.53115 -1.77986 -5.89667 +415 1 7.21985 0.783193 18.3638 -3.94277 -6.88163 -25.1551 +416 2 7.12969 0.383485 17.4575 9.77138 9.98351 24.3944 +417 2 6.41237 1.28912 18.5059 -6.03182 -4.67978 5.08395 +418 1 15.9996 18.4041 13.9383 18.1315 -1.4443 -10.5581 +419 2 15.071 18.4425 13.7445 -14.3326 2.53282 3.85714 +420 2 16.1651 18.6473 14.8506 -8.9044 -3.87569 12.2679 +421 1 10.1939 4.54115 16.2821 35.3159 -4.68875 2.87762 +422 2 11.1919 4.40884 16.3129 -34.2522 14.5881 -3.55905 +423 2 9.86192 3.67371 16.0442 -3.43039 -7.24249 -0.81883 +424 1 15.9323 17.7355 4.44233 22.6638 -20.6434 -12.8847 +425 2 16.5412 -0.18272 4.5755 6.4476 10.7336 -1.45992 +426 2 15.0915 18.0468 4.70328 -34.4096 13.9436 14.4512 +427 1 6.99117 17.4686 13.8836 -42.0334 -7.7574 -17.1448 +428 2 7.47631 17.7428 14.6303 20.6357 14.1189 34.523 +429 2 7.65356 17.3815 13.215 15.8945 -3.28854 -19.4769 +430 1 13.2291 6.49408 6.5607 17.0277 2.09005 0.593761 +431 2 14.1816 6.76782 6.52286 -25.3304 -6.60509 -4.73803 +432 2 12.9166 6.35235 5.64754 5.89534 0.461784 7.57918 +433 1 7.85324 2.32148 9.35275 5.46391 6.9162 26.9577 +434 2 7.3686 2.17076 10.1976 2.69269 5.61176 -14.2633 +435 2 7.26481 2.08775 8.6472 -14.0957 -9.57593 -14.6111 +436 1 15.2023 14.7793 13.7187 7.74208 -16.2001 -4.59991 +437 2 14.8319 14.9596 14.5759 -4.08925 6.59301 14.3355 +438 2 15.0747 15.5488 13.1771 -7.6118 10.0658 -7.58078 +439 1 9.41047 8.32341 3.83123 -6.47708 13.1987 -5.34522 +440 2 10.2452 8.80483 3.85219 3.73168 3.01968 4.76716 +441 2 9.63137 7.40393 3.95808 -1.29777 -11.5098 0.542939 +442 1 17.7649 13.5922 16.3898 -11.4367 -25.6902 16.7919 +443 2 16.7908 13.5407 16.3666 6.32242 -2.67761 -0.626712 +444 2 17.9873 14.3645 15.8914 0.275374 22.0623 -11.5119 +445 1 4.92213 10.5724 2.8597 -4.83644 2.51404 -15.3254 +446 2 5.59736 10.2151 3.4378 8.5726 -2.027 3.49443 +447 2 4.66951 11.4171 3.23999 1.02108 -1.77966 3.70944 +448 1 3.74742 8.38157 10.0278 -2.2319 9.94706 -11.0912 +449 2 3.89489 9.30484 9.7273 -4.74563 -10.9217 8.16333 +450 2 3.84233 8.40088 10.9831 -0.997449 0.744123 6.62097 +451 1 15.9666 6.96875 6.01253 -14.8276 15.8227 3.08109 +452 2 16.7817 7.37259 6.30064 12.9112 7.94175 5.43996 +453 2 16.2196 6.12219 5.66656 5.41287 -21.5059 -0.527712 +454 1 15.1391 7.15478 9.02923 3.95319 -30.3017 38.192 +455 2 15.9165 7.52141 9.44882 9.73374 3.98045 10.059 +456 2 15.0698 7.60427 8.22918 -5.81948 28.1077 -46.3627 +457 1 6.22822 12.9188 12.7298 1.31868 -8.19268 -13.1839 +458 2 6.88351 12.2656 13.01 8.10485 3.82836 6.8834 +459 2 6.11855 13.5785 13.4162 1.19396 9.04898 12.3458 +460 1 12.1253 4.52441 13.1066 -23.5121 -14.293 -11.093 +461 2 12.4631 4.60406 14.0095 -9.44452 -2.69015 3.06865 +462 2 11.2831 3.97256 13.0795 31.8956 18.265 6.80246 +463 1 11.4055 8.12657 7.94639 -16.7563 2.96014 -17.3287 +464 2 11.9383 7.50834 7.43372 10.7385 -1.00284 -0.366803 +465 2 11.8652 8.24712 8.77366 5.83315 -1.26494 14.2429 +466 1 17.1037 10.8819 7.56719 -22.1575 4.54299 3.0458 +467 2 17.7705 10.2842 7.28531 25.0286 -24.4015 -2.83309 +468 2 16.8908 11.3655 6.76798 -3.05919 12.9941 -4.73253 +469 1 5.25302 18.1256 10.9232 26.818 -0.191878 -4.18594 +470 2 4.8269 17.8089 11.6994 -14.1597 -10.1429 18.6642 +471 2 4.64144 17.9747 10.2197 -19.8227 3.49229 -23.3423 +472 1 7.59833 17.4619 1.74995 8.37542 2.1771 -36.4257 +473 2 8.02215 16.748 1.21035 -16.0406 12.4022 13.5887 +474 2 7.374 18.1677 1.08602 7.01745 -13.9463 17.8331 +475 1 1.92633 12.907 13.6044 0.0880561 -5.46821 -16.7511 +476 2 1.47807 12.3822 14.2652 -4.39349 -7.86198 7.054 +477 2 2.32754 13.632 14.072 3.07665 17.0427 10.8635 +478 1 9.50987 6.80039 14.836 2.18935 -20.8269 12.8739 +479 2 9.79082 5.96037 15.3114 -4.54962 20.4196 -21.9392 +480 2 9.66995 6.7436 13.8735 6.47407 0.337666 8.03802 +481 1 15.2827 4.32341 10.7768 10.307 9.68599 -4.89646 +482 2 16.2397 4.0919 10.6916 -21.0983 9.39835 9.69703 +483 2 15.2266 5.10894 11.3663 5.46907 -15.4805 -5.79884 +484 1 11.3016 6.20596 0.140794 12.6043 6.09542 0.747046 +485 2 11.4786 5.29078 18.6344 12.8703 -22.3778 -2.75052 +486 2 10.381 6.25156 -0.0726873 -21.1699 14.4442 -0.985902 +487 1 -0.0715916 11.4097 14.9721 22.1692 -7.15633 35.3796 +488 2 18.1992 11.7732 14.1947 -21.0416 8.6568 -29.4322 +489 2 -0.201181 12.1402 15.5966 -0.594523 -4.50066 0.166015 +490 1 7.04588 9.27411 7.30476 9.145 16.929 -11.701 +491 2 6.64583 8.45304 7.57308 -6.76023 -15.305 10.0219 +492 2 7.98749 9.10222 7.20319 2.10913 -2.81405 2.65036 +493 1 18.3255 15.3308 12.2943 -10.9271 3.22482 1.76971 +494 2 0.551901 15.6023 12.004 16.2571 0.370549 -2.10144 +495 2 17.7334 15.6802 11.6169 -1.97195 2.58378 -3.71708 +496 1 16.5011 4.39937 5.27673 4.48444 11.2976 -56.5136 +497 2 16.7777 3.84422 5.96849 7.0389 -19.8316 37.8082 +498 2 17.2036 4.29545 4.59204 -6.79319 11.0559 14.2779 +499 1 17.7009 3.16012 10.7623 -11.0785 -13.2259 -8.21854 +500 2 -0.0365931 3.41438 10.9472 14.4195 -1.11458 2.04579 +501 2 17.6933 2.32175 10.2562 4.60522 6.17753 6.57508 +502 1 12.2846 -0.0106908 10.1146 7.09195 -37.1879 -10.2172 +503 2 11.3926 0.256016 10.2673 -25.9358 14.4274 7.98014 +504 2 12.8288 0.732071 10.298 19.2326 28.445 5.65892 +505 1 10.3866 9.75519 12.5017 -6.95633 -10.4248 -20.8372 +506 2 11.1983 9.82383 13.0055 7.4239 -2.70171 9.41801 +507 2 10.3064 8.80301 12.2683 1.05955 14.1529 10.144 +508 1 0.648708 2.774 7.07027 -1.36725 -4.55963 12.8723 +509 2 0.490272 3.61188 7.51443 -2.95105 4.17746 -2.75047 +510 2 1.10621 2.25999 7.75495 -4.79333 -3.92365 -3.87978 +511 1 0.307244 15.292 6.87913 -0.83379 49.2439 44.5727 +512 2 0.652444 15.3347 7.80405 -9.58611 -2.1659 -14.8737 +513 2 0.567348 14.4512 6.61032 15.5663 -52.8882 -22.8213 +514 1 17.056 6.99125 15.1184 -7.99596 0.858836 -4.56633 +515 2 17.7814 7.62276 14.9808 0.742784 -5.19204 3.90514 +516 2 17.4035 6.24942 15.6288 5.94943 -0.679765 0.413052 +517 1 9.13726 12.4999 8.01885 37.0353 0.885775 16.8739 +518 2 9.52568 11.8572 7.39973 -10.6447 2.68521 -0.695331 +519 2 8.21726 12.5875 7.87097 -30.0746 -3.81245 -10.8301 +520 1 1.21553 1.74407 2.88052 -2.59699 -2.39415 1.38589 +521 2 0.835324 2.14494 2.08419 1.70776 2.79001 2.24225 +522 2 1.71989 2.41102 3.3678 0.071784 1.92406 -2.09937 +523 1 4.07628 15.1457 9.88397 17.4433 -7.82557 -1.54586 +524 2 4.111 15.2412 8.92029 0.253189 0.655179 -3.36934 +525 2 4.94389 14.7737 10.148 -8.68797 4.30724 -10.2942 +526 1 7.35101 2.21809 14.6867 -7.35168 5.20952 -5.71558 +527 2 7.12719 1.57839 13.9999 0.606569 0.313122 2.88765 +528 2 7.62455 3.00796 14.1978 2.82745 -2.40467 5.3071 +529 1 18.457 14.6023 2.16488 -22.5257 23.4253 1.52633 +530 2 0.650438 15.0238 2.37846 9.31401 -4.06208 0.652559 +531 2 17.8015 15.3468 2.21006 9.59865 -20.266 -2.54542 +532 1 9.9778 2.69966 12.9163 0.655502 16.6224 11.2027 +533 2 9.96654 2.13525 12.1425 -5.01566 -7.38072 -9.38582 +534 2 9.27217 3.36428 12.8011 2.98946 -10.098 -0.342741 +535 1 2.95791 8.92102 13.0894 10.3197 8.62466 2.37945 +536 2 3.25022 9.8484 12.9226 -2.55555 -16.3803 0.657875 +537 2 3.7553 8.44758 13.4136 -17.8894 4.38499 -5.11642 +538 1 3.26012 8.5452 3.75851 7.68136 4.64814 -61.3797 +539 2 3.65213 9.34274 3.2957 -8.84339 -23.8918 18.3111 +540 2 3.19772 8.72964 4.66662 3.169 13.2307 40.2657 +541 1 5.70723 7.22602 8.61089 15.0471 5.15238 -9.7988 +542 2 5.61347 6.27934 8.4361 -3.3163 0.301479 7.52532 +543 2 4.97449 7.5436 9.15453 0.52499 -8.4302 1.10573 +544 1 14.8706 1.4621 1.8863 1.70998 27.5213 20.9307 +545 2 14.7201 2.23316 2.46749 -8.28585 -15.753 -0.675778 +546 2 15.5631 1.82311 1.33978 3.90729 -10.8233 -20.0391 +547 1 8.4891 15.095 0.746196 -1.67248 3.44686 2.60315 +548 2 9.16152 15.1411 1.43932 5.44244 -6.16758 -2.29782 +549 2 7.78914 14.5375 1.12422 -1.25934 1.00196 -2.01266 +550 1 15.531 1.37665 7.20033 20.0832 14.6351 13.3031 +551 2 14.8916 0.843079 6.76136 -18.4007 -14.9103 -14.8508 +552 2 15.066 2.19014 7.43626 -3.82192 3.26637 1.54172 +553 1 5.03616 12.9919 18.445 -16.5564 -3.92778 -1.34985 +554 2 5.49952 13.0651 0.633359 3.65082 -0.909975 11.8673 +555 2 5.58799 13.4788 17.838 5.35286 -1.67587 -4.32886 +556 1 15.4004 8.57696 18.1096 -13.5133 -17.3986 23.7812 +557 2 15.6963 9.177 17.4428 12.1428 17.8023 -17.443 +558 2 15.2132 9.11981 0.25138 2.83515 1.87454 -5.46736 +559 1 12.0742 3.0873 18.3015 -13.0771 12.9456 1.32203 +560 2 12.4416 2.71193 0.467697 5.19488 -4.15516 -6.31478 +561 2 12.3414 2.59119 17.5164 7.34103 -8.20972 9.84797 +562 1 13.1603 12.6784 5.14975 4.6094 5.88635 0.276196 +563 2 13.6665 11.971 4.72065 -1.49243 -3.38503 8.68718 +564 2 13.2851 12.6103 6.1136 1.29016 -0.295852 -5.09341 +565 1 6.06548 7.22062 0.130395 -10.0215 14.1887 -9.78073 +566 2 5.90478 8.1622 -0.126677 10.3505 -23.4507 13.8616 +567 2 5.20282 6.91875 0.452817 7.86884 -4.47391 0.318594 +568 1 17.6551 15.8705 14.9463 -5.31761 6.83655 -25.2986 +569 2 16.721 16.066 14.8837 -6.35164 3.20497 21.4179 +570 2 17.8286 15.8261 13.9944 18.3936 -6.902 3.79502 +571 1 13.1598 0.895115 16.6829 -10.2787 13.0231 -1.21317 +572 2 14.0985 0.838925 16.8484 11.7714 -2.60716 3.82434 +573 2 12.9094 -0.0108285 16.49 -7.09766 -5.67505 2.02872 +574 1 10.9245 14.5193 7.39494 -10.4099 -10.8827 23.6465 +575 2 10.1209 14.2503 7.91799 23.546 5.98273 -19.3945 +576 2 11.6246 13.8906 7.65805 -5.45953 8.29317 -8.96944 +577 1 17.5666 8.45977 2.1077 -2.45541 -18.4017 -7.84499 +578 2 16.6916 8.4078 2.54921 14.2221 -0.924117 -8.74119 +579 2 17.6058 7.68446 1.4828 -2.53767 24.5137 15.8214 +580 1 12.3693 7.85876 1.99742 11.9287 1.39128 11.652 +581 2 11.9574 8.70597 1.81668 -2.84663 4.1279 -5.57453 +582 2 12.0661 7.22941 1.33154 -5.87406 3.00715 -1.1515 +583 1 12.0244 14.6632 10.3909 28.0505 -1.98221 6.53788 +584 2 12.2154 13.9026 9.84664 0.841551 -5.23881 -6.52272 +585 2 11.0973 14.8027 10.3697 -37.2752 0.615569 -5.61626 +586 1 6.83101 6.95959 15.54 -26.922 -25.3261 -7.84618 +587 2 7.74646 6.93869 15.3131 28.0025 5.72032 -4.23149 +588 2 6.70706 7.70294 16.1074 0.47288 18.1258 13.2198 +589 1 7.99181 4.56873 13.323 -17.7662 10.8645 -2.94772 +590 2 7.11502 4.75523 12.8947 23.3848 -2.11675 2.9311 +591 2 8.34221 5.42155 13.6369 -8.03699 -10.5621 -3.57795 +592 1 13.4097 12.1854 14.3195 -5.65215 6.28756 1.83858 +593 2 13.0403 11.2921 14.2436 5.24433 -3.00833 -1.58816 +594 2 13.8498 12.3732 13.4771 -2.55607 -2.02901 -2.35573 +595 1 14.6454 9.43305 7.28195 10.7596 15.6461 6.41649 +596 2 15.5174 9.89596 7.36949 -20.7431 -7.51972 6.68313 +597 2 14.0059 9.84843 7.89782 12.5114 -5.65293 -10.9965 +598 1 12.693 16.9181 3.21868 4.13721 -47.3842 -7.97708 +599 2 12.7878 17.338 4.04875 4.47204 15.8163 32.4195 +600 2 12.4838 17.5994 2.61833 -10.0532 31.8516 -27.8744 +601 1 1.00841 7.13021 17.3596 12.9632 -6.47488 11.204 +602 2 0.140567 7.22584 17.7618 -2.41623 -7.13214 2.78808 +603 2 0.956632 7.61621 16.5408 -0.0488819 7.87685 -11.8994 +604 1 12.917 4.94058 15.6965 -33.9833 6.00302 -1.61153 +605 2 13.6432 4.4005 15.9475 28.608 -13.7192 2.54357 +606 2 13.1955 5.85458 15.7909 9.71851 9.87704 0.635703 +607 1 2.3887 3.3689 5.15584 14.955 -15.9692 -52.0278 +608 2 1.80093 3.08916 5.81858 -25.593 -10.9876 33.4797 +609 2 2.79381 4.15677 5.46164 14.8077 31.4017 13.6729 +610 1 8.27435 11.0395 13.6153 -37.0795 23.6732 -65.6931 +611 2 8.36475 10.9269 14.5167 14.9976 -12.7369 63.1872 +612 2 9.08207 10.7919 13.1709 13.5323 -11.5041 2.55762 +613 1 12.9711 1.50053 13.2758 -7.16838 -21.0368 21.1096 +614 2 13.525 1.50324 12.5105 16.6349 2.94139 -20.1138 +615 2 12.6114 2.3778 13.3258 -6.20414 13.0805 -2.33086 +616 1 6.55993 13.5741 2.17335 4.5265 3.63418 -23.4358 +617 2 5.93511 13.8533 2.83279 -12.7543 7.85744 13.7798 +618 2 7.20659 13.0527 2.65116 1.25385 -4.10852 0.808212 +619 1 15.8831 6.47501 12.6409 22.0814 4.72601 -0.603906 +620 2 16.4738 6.98335 12.028 -14.2245 -11.2946 14.6347 +621 2 16.3705 6.43226 13.5009 -10.5632 5.96191 -15.5708 +622 1 16.8031 0.705923 9.56407 -2.28595 11.5891 -8.26827 +623 2 16.6552 18.4511 9.84906 2.3526 -17.7501 5.98934 +624 2 16.3731 0.773302 8.69375 1.62838 3.03603 0.698224 +625 1 6.10625 11.6157 8.28914 -3.08711 55.9701 7.34602 +626 2 5.36711 11.2964 8.79127 -16.3164 -7.54559 6.80515 +627 2 6.5283 10.8686 7.94164 19.8706 -42.6353 -12.8098 +628 1 2.81358 8.70539 0.376179 36.8039 -5.08598 16.3747 +629 2 2.33554 8.23944 18.3571 -22.6922 -9.90678 -17.9478 +630 2 2.28148 9.42572 0.700092 -14.5476 7.98537 3.82577 +631 1 10.114 10.4289 6.56839 -5.48816 -6.21666 7.2072 +632 2 10.5648 9.70982 7.03635 1.99723 -0.0329781 -1.13968 +633 2 10.3487 10.347 5.64237 7.8387 0.67993 -6.97128 +634 1 6.81211 15.7679 6.65103 -0.348958 5.58939 -1.23617 +635 2 7.12762 16.1335 7.48534 -0.336507 -3.46393 3.99871 +636 2 7.12562 16.4168 5.9986 -1.75978 -6.48118 -4.29666 +637 1 6.49059 12.9347 5.74014 0.722488 11.3509 6.39713 +638 2 6.52544 13.8593 6.05125 4.61742 -7.45139 -3.43251 +639 2 6.13117 12.4341 6.48422 -0.637044 1.07223 -0.836688 +640 1 16.7722 12.5296 9.75372 -10.3378 8.80589 22.9139 +641 2 16.9709 11.8837 9.07779 5.41942 -3.21474 -11.15 +642 2 17.3199 13.309 9.62307 0.866334 -2.28521 -6.10033 +643 1 6.18734 2.89369 2.76381 6.70118 21.5641 -20.0406 +644 2 6.53969 3.77128 2.46465 -8.05809 -16.0544 14.4298 +645 2 5.6766 2.59589 1.99155 1.09601 -8.68373 7.94101 +646 1 10.8178 3.09588 3.24672 1.33393 -8.05069 0.148042 +647 2 10.2056 3.80475 3.46561 0.323029 3.07521 -1.63087 +648 2 10.3998 2.55919 2.55618 -0.935454 8.00813 2.52947 +ITEM: TIMESTEP +70 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.83052 6.78564 17.8747 4.81039 14.7119 7.93216 +2 2 8.02044 7.08583 18.306 -2.95347 -6.04078 -1.17349 +3 2 8.57794 6.09723 17.2713 -4.49598 -11.7014 -7.63976 +4 1 0.124161 8.31212 6.74558 -2.09679 -1.27724 -21.4903 +5 2 0.320991 8.02726 5.80661 -3.30063 7.0305 29.7013 +6 2 0.593986 7.72695 7.35611 1.84479 -1.64007 -4.64643 +7 1 8.55341 0.214487 6.89794 4.20955 -4.60902 11.3327 +8 2 9.45965 0.255338 6.58274 3.95615 -0.229119 -0.443755 +9 2 8.09377 0.850204 6.35793 -6.3823 8.35705 -5.64785 +10 1 6.52177 1.69631 11.7106 -29.0447 -4.52087 -3.66773 +11 2 5.85029 2.25877 12.1616 13.2184 -10.2105 -7.98022 +12 2 6.00884 0.936302 11.3174 15.6542 21.0994 14.986 +13 1 6.92822 5.5902 2.37948 23.4336 -17.8876 -5.1013 +14 2 6.5261 5.8779 3.18071 -18.514 8.45901 19.042 +15 2 6.74676 6.28055 1.75003 -1.36947 6.04298 -15.8103 +16 1 16.1916 10.2374 16.1412 -24.0328 -6.0953 4.14694 +17 2 17.0138 10.497 15.7581 19.6671 8.99174 -7.62884 +18 2 15.6617 11.0456 16.2513 11.6446 -5.87426 0.419849 +19 1 10.7179 14.9528 2.30402 9.26606 5.76352 20.4147 +20 2 10.604 14.349 3.06349 2.85769 5.88214 -5.84145 +21 2 11.1755 15.7297 2.69585 -5.79349 -8.7688 -7.8832 +22 1 17.1683 8.21322 10.7989 1.82063 -1.23871 -1.95171 +23 2 16.5117 8.80699 11.1832 -0.385781 3.51193 7.00123 +24 2 17.9642 8.75858 10.6912 0.976865 0.382705 -5.65698 +25 1 14.6466 15.9322 16.4418 -21.6809 -6.01765 9.50279 +26 2 13.7097 16.2329 16.4085 18.6708 -4.64396 -3.84163 +27 2 14.6751 15.3815 17.2568 4.92661 10.5457 -14.6576 +28 1 12.1005 13.348 0.567693 14.0677 -11.0124 3.49805 +29 2 11.7977 13.4785 18.3054 -3.25303 6.53047 -2.60123 +30 2 11.7369 14.0166 1.16546 -7.92056 -0.136763 -7.41856 +31 1 9.34615 5.48792 3.88275 21.7787 0.248377 2.40385 +32 2 8.84331 5.37966 4.67443 -9.14 -4.08483 27.4632 +33 2 8.65688 5.52523 3.23949 -14.702 1.76912 -26.3373 +34 1 1.6606 4.00652 11.6035 4.04251 -10.384 -6.17332 +35 2 1.67583 4.94617 11.8049 -2.44143 11.0832 5.72027 +36 2 2.2695 3.55993 12.2146 -3.92557 1.72629 -0.38872 +37 1 2.08139 6.85853 8.20375 5.25116 9.81515 7.60897 +38 2 2.56831 7.24635 8.96213 -7.90159 -5.93168 -10.5698 +39 2 2.00199 5.91426 8.39105 -0.650687 0.0621593 5.33933 +40 1 5.36768 4.45674 7.91405 -3.32795 5.87339 3.17518 +41 2 5.46396 3.51228 8.0104 5.66802 -14.4695 -1.12836 +42 2 4.78412 4.56623 7.16078 -4.98903 9.02084 -4.56071 +43 1 3.31193 2.91026 17.4243 5.25503 -22.5991 -0.535021 +44 2 3.97925 3.43469 16.9765 8.2555 0.833912 -8.18173 +45 2 2.82292 3.51814 17.9594 -9.74498 21.4045 11.9966 +46 1 7.44628 5.47686 6.16962 4.83779 4.18627 -38.8589 +47 2 7.80337 6.02378 6.84422 19.7966 19.2933 17.1246 +48 2 7.08839 4.74785 6.63594 -15.5951 -22.4752 14.0992 +49 1 9.79841 6.99298 12.0115 -14.4173 0.175621 -19.7413 +50 2 10.2338 6.25953 11.5352 -7.27244 10.6531 4.67439 +51 2 9.07403 7.33711 11.4082 20.5779 -11.7539 16.8314 +52 1 14.0932 3.73018 8.11294 -2.35225 21.206 2.79521 +53 2 13.7164 4.53948 7.70027 6.06412 -15.1972 7.35067 +54 2 14.2932 3.96864 9.04107 -1.96145 -2.4542 -11.4015 +55 1 4.4865 17.2305 3.91995 2.87421 -17.2964 21.8602 +56 2 5.37817 17.5632 3.85852 13.1015 6.2627 -4.15101 +57 2 4.01126 17.4425 3.12603 -6.70645 13.3364 -16.7923 +58 1 16.3503 16.556 10.4027 -28.8153 -10.9362 -6.11544 +59 2 15.5262 16.5238 10.94 14.5825 4.08322 -8.19499 +60 2 16.0782 16.1167 9.56389 6.69544 5.4961 14.7824 +61 1 2.00781 4.81695 0.19428 -16.7794 -3.94444 -13.379 +62 2 2.36068 5.21925 0.976813 15.1603 4.4174 16.1734 +63 2 1.77343 5.5764 18.2905 0.379182 1.41768 -5.2961 +64 1 11.3582 13.2716 16.3898 -3.93488 16.8957 9.12151 +65 2 10.9039 12.4355 16.5285 -2.10099 -6.82713 -1.65452 +66 2 11.9323 13.1324 15.638 7.04428 -4.38588 -8.74921 +67 1 10.1365 10.938 16.8467 -2.82235 24.3376 4.32555 +68 2 10.5718 10.0987 16.7812 6.05632 -17.4389 0.305733 +69 2 9.20542 10.7786 16.7086 -10.6888 -4.42603 -1.21793 +70 1 11.8139 17.4685 13.4625 16.8497 6.47801 1.45884 +71 2 12.3399 16.8066 12.9857 -2.09189 7.12722 0.625626 +72 2 12.305 18.316 13.3535 -13.8327 -6.90215 0.736174 +73 1 6.44924 9.38958 12.2401 6.69888 0.367183 -15.9058 +74 2 7.02028 9.14259 11.4734 -10.412 6.11649 20.9521 +75 2 7.00474 9.9221 12.8226 3.16796 0.0903621 -0.913647 +76 1 16.2861 12.8631 2.69282 -5.5095 27.1919 6.93721 +77 2 17.1297 13.3403 2.5399 -11.4064 -12.6315 1.20497 +78 2 15.6248 13.5969 2.82884 15.7371 -22.5818 -6.03687 +79 1 0.705842 12.6958 5.89372 11.1118 0.602373 24.8353 +80 2 1.18521 12.4959 5.09265 -4.47491 1.87676 -19.0631 +81 2 18.418 12.5564 5.72922 -11.8137 -1.703 -8.70405 +82 1 5.28198 16.3804 18.4185 -2.246 1.3069 9.83982 +83 2 5.62966 15.5825 18.0261 2.19299 -6.30074 -9.03385 +84 2 5.78103 16.4802 0.590407 -0.738213 6.24336 1.72583 +85 1 0.669378 7.71651 4.13384 -59.2278 -40.1014 26.2385 +86 2 0.0696389 8.03317 3.4616 -5.2936 5.59306 -12.1338 +87 2 1.48105 8.07531 3.93226 66.8664 27.2164 -22.0097 +88 1 3.17848 8.98449 6.48797 -11.6429 31.0556 -28.5774 +89 2 3.69754 8.52221 7.10624 17.5545 -20.4274 28.0681 +90 2 2.28321 9.06095 6.81713 -8.12873 -6.01142 5.66961 +91 1 7.27057 10.3561 16.259 12.8547 -0.986094 -7.05958 +92 2 6.52139 10.8488 15.9387 -6.88577 4.52419 -2.25862 +93 2 7.07809 10.1849 17.1799 -5.89204 -3.21212 7.89434 +94 1 11.0493 0.926342 5.00492 7.6282 -0.312775 10.2028 +95 2 11.2745 1.78939 4.63491 -8.49938 0.0964505 -4.50291 +96 2 10.791 0.378052 4.25157 -0.730025 2.38059 -0.222793 +97 1 4.31171 2.85627 13.1955 -2.92819 26.6809 -11.7177 +98 2 4.37585 3.38692 13.9969 4.42074 -3.40265 4.05123 +99 2 4.21422 1.95476 13.4751 -3.58996 -22.8444 6.9477 +100 1 8.4068 10.257 1.78795 4.04191 -13.9705 -5.37842 +101 2 8.26785 10.8775 2.49552 -4.14797 15.7472 11.4003 +102 2 8.5529 9.42866 2.25521 3.43453 -4.46737 -1.06154 +103 1 10.2803 1.70096 15.4762 8.76071 -4.61575 -1.32446 +104 2 11.1657 1.41822 15.7142 3.10462 2.167 2.36838 +105 2 10.3075 1.82832 14.5156 -8.33356 3.27592 2.91474 +106 1 2.63173 12.8085 7.89063 4.0959 -9.21484 -0.859497 +107 2 3.2295 13.3973 7.41028 -2.49756 4.22571 1.84267 +108 2 1.98308 12.5062 7.24287 -1.99659 4.67741 -0.497136 +109 1 3.82895 11.7184 5.01628 -2.65331 8.28036 11.6201 +110 2 3.66291 11.1157 5.74556 0.426771 -3.98214 -1.1075 +111 2 3.01542 11.7805 4.50368 -0.128738 -0.0731644 -2.81963 +112 1 6.76514 14.4734 16.965 3.61018 3.02569 -11.8589 +113 2 7.44445 15.1431 17.0872 4.2046 -3.50831 2.36163 +114 2 6.5725 14.4959 16.0119 -5.95898 4.08629 6.49151 +115 1 14.2172 14.5156 3.23512 -15.7654 4.80027 20.0484 +116 2 13.9157 15.4376 3.23841 -0.320177 -6.15912 -4.56224 +117 2 13.7912 14.1249 4.0321 9.04818 0.126488 -15.8424 +118 1 8.62194 18.1001 16.0659 -23.21 2.71751 -2.03066 +119 2 9.16623 17.3958 16.3546 8.59431 -35.107 8.94544 +120 2 9.24682 0.159724 16.0687 7.59352 33.2076 -10.3682 +121 1 4.64785 1.66473 4.88429 20.0976 -32.3539 12.8345 +122 2 3.91841 2.23972 4.98678 -27.2909 21.6553 1.42112 +123 2 5.29938 2.12424 4.3745 8.75708 11.4615 -15.3566 +124 1 14.996 12.6195 16.4803 11.4842 8.30008 2.93566 +125 2 14.5677 12.8295 17.3315 -5.03395 -0.949445 -14.8823 +126 2 14.3989 12.5973 15.7101 -8.95177 1.91572 10.2236 +127 1 15.728 18.434 16.8656 -21.8007 21.3443 -35.9839 +128 2 16.2692 18.4514 17.6234 28.2096 -0.560819 33.2727 +129 2 15.2446 17.617 16.9069 0.184765 -20.6285 -2.2654 +130 1 1.36479 1.27889 16.6468 -16.7944 -10.044 -5.49533 +131 2 2.14801 1.79564 16.8219 8.14362 6.44014 2.70449 +132 2 0.693336 1.65446 17.2331 2.17778 -0.49248 0.882874 +133 1 18.205 4.38071 15.9717 -12.5383 1.08179 -4.34425 +134 2 17.9247 3.87865 15.1967 2.33887 0.121173 2.56773 +135 2 0.514445 4.3883 15.9876 8.17504 0.178033 -1.34417 +136 1 12.1632 17.0104 16.1415 17.8243 8.47052 -8.26904 +137 2 11.4339 16.4838 16.4748 -11.8796 -0.396392 0.7857 +138 2 12.1013 17.0682 15.1696 -12.6199 -2.93135 7.53111 +139 1 16.1201 2.6287 18.1864 3.80406 -3.99791 19.9987 +140 2 15.7935 3.50022 18.4009 -8.69312 10.1277 7.25942 +141 2 15.8264 2.47036 17.3057 -5.74882 -3.05042 -27.5508 +142 1 6.63908 13.8237 10.1059 1.54133 -19.2408 -0.896874 +143 2 6.60488 13.4547 10.9999 -2.4531 4.12781 1.41157 +144 2 6.6237 13.027 9.53669 -1.978 12.9815 -0.0933135 +145 1 10.1367 18.5192 2.71126 14.9692 1.08893 5.4249 +146 2 10.5375 0.290475 1.93143 -3.72697 -2.23961 5.76435 +147 2 9.31873 18.1319 2.42821 -14.2623 -5.70844 -7.57952 +148 1 3.05388 17.7183 6.14163 -17.3097 -9.85118 -22.5426 +149 2 2.24205 17.5791 5.58071 14.4512 3.50974 23.581 +150 2 3.73807 17.7208 5.46344 2.0394 5.03095 2.09251 +151 1 12.6118 16.8054 7.95495 4.58219 1.15158 -10.9791 +152 2 11.8555 16.2225 7.90842 -7.26482 -13.9478 -6.78863 +153 2 12.3849 17.4156 8.64585 -0.135632 15.5831 16.1371 +154 1 14.8975 15.2817 8.22586 -10.0433 25.2404 1.15436 +155 2 14.1016 15.8482 8.35876 13.2826 -12.9576 -5.35538 +156 2 15.2902 15.6258 7.39629 -1.79461 -13.1873 12.9757 +157 1 17.8242 18.245 0.290753 35.0262 5.69882 -22.3559 +158 2 18.562 17.7688 18.4584 -26.5201 3.44978 21.3008 +159 2 18.2553 0.461923 0.458274 -15.0979 -6.94564 5.00195 +160 1 0.811942 10.4929 1.40956 8.77271 16.3938 -17.0751 +161 2 0.0922351 9.87336 1.50209 -12.9574 -8.99075 8.33498 +162 2 0.506251 11.1761 0.770938 6.09002 -9.92994 11.4815 +163 1 1.80057 12.2567 3.3157 -0.00821892 -5.58838 -28.0373 +164 2 1.51905 11.5718 2.65287 2.57103 10.7079 19.8708 +165 2 2.13035 12.9839 2.7472 -5.7627 -4.92842 11.1942 +166 1 0.668516 17.2609 4.94683 -35.85 3.98858 25.1078 +167 2 0.0697466 18.0029 5.19004 17.5579 -5.46754 -17.9658 +168 2 0.309089 16.5456 5.51301 20.6369 3.3795 -13.3957 +169 1 1.1258 0.902495 9.33726 -12.4564 -3.06084 39.8122 +170 2 1.2842 0.722879 10.3134 -2.51149 4.27857 -26.5162 +171 2 0.280567 0.461704 9.18062 1.78742 1.97705 -4.09399 +172 1 16.751 2.38387 13.3212 3.93571 18.018 2.1702 +173 2 16.8889 2.64612 12.3995 3.13812 2.89192 3.07637 +174 2 16.5572 1.45381 13.2916 -4.67688 -18.3777 2.25645 +175 1 2.721 15.8932 12.0356 -10.4038 6.64935 25.1991 +176 2 2.99704 15.5189 12.8835 -2.56405 3.43208 -4.36032 +177 2 3.3254 15.553 11.3859 5.26998 -2.53603 -11.8474 +178 1 16.4132 15.6174 6.13158 -30.6236 -31.2218 7.18947 +179 2 17.2889 15.5331 6.46785 25.936 1.45578 4.51193 +180 2 16.388 16.3213 5.51027 2.55474 24.6255 -21.834 +181 1 5.75165 5.17156 11.8076 -10.0158 20.8309 8.83951 +182 2 5.58328 6.03799 12.2608 0.394348 -20.1746 -10.5178 +183 2 4.95414 4.6515 11.9927 8.5068 -2.87995 -2.26002 +184 1 15.1308 4.87532 0.804768 27.2949 -1.75024 -19.8676 +185 2 14.8777 4.72649 1.70618 -7.53991 -8.08598 20.9925 +186 2 14.4372 5.36761 0.397065 -18.333 11.5318 -5.57633 +187 1 16.3608 16.424 1.96087 0.545069 28.5814 -7.81874 +188 2 15.9402 16.8572 2.72963 9.40909 -7.94755 -2.88814 +189 2 16.7928 17.1706 1.4719 -7.75465 -17.4072 6.82817 +190 1 0.195497 4.8427 3.9016 -20.8114 -16.3238 -7.36148 +191 2 0.347935 5.77048 3.88737 2.90582 31.823 0.953261 +192 2 1.01225 4.48793 4.21241 18.9183 -15.2676 9.08502 +193 1 2.99687 15.0761 15.1729 -7.80035 25.004 -19.9303 +194 2 2.75027 14.6107 15.9518 -1.28992 -16.7566 29.7079 +195 2 2.55205 15.9391 15.3182 6.19364 -5.6546 -9.94962 +196 1 1.13925 14.6508 9.53021 19.9076 23.5081 3.98588 +197 2 2.07639 14.8825 9.77663 -29.323 -13.131 -7.88186 +198 2 1.04812 13.6993 9.55892 5.54263 -6.82879 4.76298 +199 1 13.5171 16.5199 11.5195 20.4201 8.76324 22.1576 +200 2 12.9867 17.257 11.2155 -0.855064 7.64635 -14.0191 +201 2 13.0442 15.7467 11.2378 -7.08331 -12.4379 -10.7884 +202 1 4.66723 1.48136 0.73322 23.0149 3.26353 10.1864 +203 2 3.99044 1.945 0.247475 -7.51763 5.99594 -9.81004 +204 2 4.21698 0.879204 1.33273 -6.6714 -6.19828 -5.18082 +205 1 1.48126 18.5865 11.8932 5.77456 11.9109 13.6761 +206 2 1.45047 0.509997 12.7065 -0.655319 -12.4833 -18.3988 +207 2 2.16842 17.9125 12.0331 -8.54366 2.69761 2.01722 +208 1 11.4638 10.1444 4.04596 -29.9846 -9.43843 22.7531 +209 2 11.586 10.5695 3.21678 -1.49335 12.1472 -28.3165 +210 2 12.3366 9.99459 4.35585 30.6386 -4.62302 8.08877 +211 1 8.15809 12.1698 3.75544 16.5318 -12.8496 -25.3624 +212 2 9.0168 12.5594 3.97136 -0.0903232 2.9732 11.2136 +213 2 7.55758 12.2779 4.48666 -4.55936 7.15494 21.2951 +214 1 14.57 4.03338 3.33424 -15.9396 -3.34089 -13.9779 +215 2 15.2475 4.30951 3.93522 14.2067 0.133456 17.245 +216 2 13.7488 4.35662 3.71839 -4.37522 2.77806 -1.52286 +217 1 5.69573 1.64484 7.55416 47.4861 32.5669 -28.9041 +218 2 5.02314 1.22164 8.01158 -49.1519 -34.4826 29.3881 +219 2 5.51675 1.48645 6.61188 -4.44278 2.0561 3.75596 +220 1 17.8757 1.08291 4.8338 -2.11434 0.172647 4.71576 +221 2 18.4455 1.46692 4.16357 3.67184 -2.89676 -9.33974 +222 2 18.0165 1.6381 5.60499 -0.396504 -0.0112538 6.48923 +223 1 6.85338 9.35555 4.52322 8.01303 -7.73923 12.5712 +224 2 6.71294 9.49068 5.48294 3.02765 -1.76203 -13.5451 +225 2 7.79052 9.06961 4.44068 -13.079 3.18293 -1.46589 +226 1 2.62197 14.8521 2.02937 -10.5221 3.39156 -23.0918 +227 2 3.43005 14.7674 2.51892 12.1264 -2.78802 16.39 +228 2 2.89555 15.1253 1.13827 -2.73698 -5.91865 10.4405 +229 1 17.3299 12.9421 13.1931 -12.7738 17.025 -7.03447 +230 2 16.4383 13.2606 13.4479 14.3464 -2.45707 -5.73497 +231 2 17.7945 13.7546 12.8897 -6.22536 -14.4165 5.27249 +232 1 14.8979 10.5619 1.48982 -11.9525 28.8063 14.5441 +233 2 15.3485 11.4081 1.81139 -13.0513 -30.8314 -8.90843 +234 2 13.9324 10.6539 1.67123 25.3412 1.8999 -4.23485 +235 1 5.67595 6.67872 4.55433 0.362155 18.5292 -10.9955 +236 2 5.7867 7.61135 4.29326 0.453279 -5.37291 7.09585 +237 2 6.40948 6.48302 5.14674 -0.086512 -6.41659 5.49044 +238 1 7.99316 8.32936 10.3099 -9.88556 -13.348 -36.673 +239 2 8.52429 8.77949 9.6279 3.30308 5.35046 16.0689 +240 2 7.32365 7.86355 9.75728 7.50693 2.48224 14.219 +241 1 13.4328 18.4778 5.70681 16.0844 -0.193399 -6.38488 +242 2 12.6986 0.421386 5.55211 -13.5651 7.65576 -7.58054 +243 2 13.084 17.8957 6.37412 -0.0453673 -15.2248 15.7361 +244 1 -0.0111344 2.60704 0.305045 25.2129 -30.2702 8.72131 +245 2 17.7164 2.72495 0.164021 -32.2143 -6.6311 -9.93678 +246 2 0.303096 3.48034 0.225751 24.1306 33.5707 -2.06333 +247 1 12.8325 10.9421 9.75806 8.08682 -36.6012 3.93532 +248 2 11.88 10.8422 9.79419 -10.8426 11.3849 -4.95145 +249 2 13.0795 10.0004 9.94273 0.259667 22.5692 -5.0531 +250 1 0.642026 12.1683 11.0609 4.45464 6.09796 -5.6804 +251 2 18.3356 12.2213 11.2584 6.06715 1.14224 4.76964 +252 2 1.15053 12.4132 11.8471 -8.72956 3.82018 2.8882 +253 1 5.19121 7.35128 13.362 14.2217 -1.26987 2.88721 +254 2 5.71731 8.09811 12.9969 -6.96977 -10.5111 6.72344 +255 2 5.67215 7.04852 14.1611 -4.50302 8.90065 -9.08298 +256 1 1.17753 6.82665 11.884 -6.96202 23.1207 3.27017 +257 2 0.332868 7.13942 11.4836 19.3553 -6.8941 9.30012 +258 2 1.59694 7.61812 12.3119 -7.65201 -17.5731 -13.8958 +259 1 15.4801 9.74186 12.3501 8.02403 -36.537 -7.5848 +260 2 15.2771 10.6331 12.1319 -8.61126 25.0623 0.312061 +261 2 15.6595 9.70704 13.2832 1.37326 2.5629 11.9963 +262 1 16.5169 12.594 5.50965 10.4637 -15.548 10.5874 +263 2 16.3074 13.4879 5.77305 -4.76715 16.3332 -4.64473 +264 2 16.4013 12.5274 4.55501 -3.26126 3.70708 -8.86796 +265 1 6.31292 9.82321 0.0853393 -0.254663 19.8779 15.0366 +266 2 5.47299 10.2624 0.316114 7.63969 -1.93852 0.671735 +267 2 6.95815 10.0698 0.784254 -6.58085 -1.04763 -9.09577 +268 1 12.2316 6.09819 4.0135 -11.5327 11.7492 -3.18772 +269 2 12.1819 6.93481 3.49894 6.0574 -18.2652 4.97925 +270 2 11.3139 5.7855 4.02535 4.75129 -2.10791 -0.415098 +271 1 0.346102 12.8439 0.0895734 -4.86896 0.353582 5.39062 +272 2 18.7507 13.4631 0.799834 -0.48412 -1.67542 -1.66039 +273 2 18.3682 13.0274 18.0218 -2.69393 2.08889 -5.2677 +274 1 3.5489 0.022651 8.64264 14.8213 -2.21723 6.15117 +275 2 3.34146 18.2537 7.79412 -1.37888 1.54429 -1.85278 +276 2 2.69807 0.312924 8.99074 2.91061 0.134312 -8.36673 +277 1 7.48275 17.4677 4.49597 -9.82961 -11.4008 2.47905 +278 2 7.76172 18.3639 4.65831 -0.473756 11.2371 0.709742 +279 2 7.61951 17.3416 3.55584 -1.72206 -2.44101 -5.98946 +280 1 9.27482 17.1419 12.2002 -29.9673 17.8198 -3.75997 +281 2 9.29449 16.2474 11.8858 2.76409 -17.0257 -9.00951 +282 2 9.96887 17.232 12.8306 24.004 1.27191 14.3563 +283 1 13.3881 13.0638 7.94543 23.8544 1.05207 16.0454 +284 2 13.4911 12.3591 8.61055 -7.80977 1.42534 -8.25381 +285 2 14.1677 13.6583 8.10929 -22.3675 -6.64423 -7.05202 +286 1 14.8196 2.98416 15.4059 10.9247 4.82989 11.3692 +287 2 14.1977 2.30622 15.182 -14.8004 -11.8419 -2.86461 +288 2 15.3715 3.04555 14.6288 11.3419 0.403673 -8.50968 +289 1 9.89007 15.644 16.9507 -0.476448 -13.1737 2.9886 +290 2 10.2689 14.811 16.6236 0.33136 1.14394 -2.50282 +291 2 9.50974 15.3862 17.8064 -0.51987 6.75584 -0.702029 +292 1 11.2404 8.49746 16.6126 -11.0388 -24.1902 -5.6141 +293 2 10.5493 7.95233 16.1656 11.7734 11.5748 6.95591 +294 2 11.5411 7.95338 17.3605 -0.459906 4.27214 -6.12679 +295 1 3.94653 18.1828 16.8275 -12.5536 19.575 -10.0724 +296 2 4.49583 17.6028 17.3635 4.26127 2.6886 8.36922 +297 2 3.95977 0.456308 17.1729 5.72776 -19.9128 0.46306 +298 1 2.2132 4.22212 8.91052 -3.52394 3.62108 -17.0138 +299 2 3.14576 4.09878 8.74947 8.67559 -2.34434 0.767855 +300 2 2.06536 4.03466 9.83165 -0.817379 -1.75645 17.2153 +301 1 9.87247 10.3712 9.74928 14.7683 -30.296 -5.49075 +302 2 9.62147 11.2221 9.45607 -13.6864 32.2476 -14.4563 +303 2 9.99394 10.4206 10.6874 0.365841 -1.43755 21.5864 +304 1 9.68376 0.92477 10.8522 -9.86416 -7.8375 -9.37303 +305 2 9.18791 0.169256 11.2055 11.1043 -0.796798 3.35444 +306 2 9.09399 1.23638 10.1435 10.2069 6.90097 4.69651 +307 1 9.16769 15.091 10.1956 22.4355 7.87639 6.21774 +308 2 8.9696 15.9691 9.88131 -3.17938 11.9605 -8.33522 +309 2 8.32743 14.6622 10.1389 -19.5916 -16.662 -1.08184 +310 1 0.85922 9.69743 10.2442 32.6336 -47.5631 -25.4673 +311 2 1.02374 10.6105 10.3992 -2.53948 25.7241 9.50189 +312 2 1.72313 9.35148 9.87448 -35.4256 9.68482 16.6576 +313 1 17.0256 4.81986 8.08308 31.6348 -31.2729 -9.48192 +314 2 16.3215 5.37214 8.33224 -31.3655 27.4802 10.3117 +315 2 16.9319 4.0155 8.6004 0.768816 2.34372 -1.45333 +316 1 14.8081 14.6794 0.153243 -2.85725 -11.5952 -11.9613 +317 2 15.2092 15.2804 0.771003 11.383 9.73034 15.7651 +318 2 14.0408 14.3115 0.591288 -7.92269 -3.99881 6.06231 +319 1 3.80416 11.0019 9.56526 0.623941 6.68377 2.11405 +320 2 3.77619 11.4642 10.4186 -0.043788 -6.16761 3.62327 +321 2 3.31763 11.5705 8.95624 -4.54045 6.84371 -3.4313 +322 1 11.3158 10.7476 1.45776 10.9951 -9.43983 2.74041 +323 2 11.5252 11.5694 1.01773 6.8042 14.5185 -3.76913 +324 2 10.3718 10.6573 1.35733 -14.9091 -3.38451 -2.45366 +325 1 13.1832 7.19978 12.6897 5.92706 -14.8401 5.32281 +326 2 14.1145 6.87754 12.7085 -13.0936 9.37511 -3.26372 +327 2 12.6462 6.38983 12.7968 5.91866 7.22274 -2.53959 +328 1 9.61767 1.88189 0.936979 -6.6056 8.12678 -33.3335 +329 2 8.75647 1.76915 0.468433 15.5153 -2.73343 13.4493 +330 2 10.2273 2.17983 0.230861 -6.38326 -0.489196 14.1696 +331 1 10.6523 13.47 4.56634 -17.7163 6.61907 -5.84307 +332 2 11.5562 13.1849 4.68206 11.5009 -9.86279 4.07703 +333 2 10.5151 14.0877 5.29021 -1.44258 0.681598 7.9468 +334 1 14.5213 1.69385 10.9785 0.412416 12.5139 1.3055 +335 2 15.3159 1.33414 10.5754 1.96072 -4.24727 -0.900333 +336 2 14.7412 2.63918 11.0728 -6.13642 -3.41388 -3.76294 +337 1 14.5042 12.0777 11.6111 -12.2061 0.510996 31.5423 +338 2 15.1827 12.4648 11.0978 29.2487 15.6657 -21.0239 +339 2 13.909 11.6953 10.9807 -16.843 -4.29027 -12.6849 +340 1 8.18401 5.11068 9.87002 -0.676892 -7.65738 -3.35075 +341 2 7.33939 5.06675 10.3357 0.521056 4.21206 1.1001 +342 2 8.29842 4.21721 9.50312 -0.00697362 5.6522 3.71152 +343 1 1.5768 16.9623 18.4443 13.7844 -6.06932 -11.1938 +344 2 2.08688 17.3314 17.6994 -1.29344 -1.55823 6.9248 +345 2 1.72478 16.0021 18.3853 -4.19272 5.84443 -4.03385 +346 1 1.47359 17.3466 15.3156 -41.3862 18.9515 21.4522 +347 2 1.38751 18.1942 15.8376 11.356 -22.4463 -17.1221 +348 2 0.531998 17.0202 15.2731 27.9598 4.08453 -2.72162 +349 1 3.56251 5.80266 6.06315 1.23781 -30.1986 0.952301 +350 2 2.9922 6.42371 6.50913 -3.22231 11.6367 6.59476 +351 2 4.22501 6.28135 5.5614 1.05528 7.23928 -6.44245 +352 1 12.5723 9.4951 14.2463 -14.1947 49.7353 4.36555 +353 2 12.9086 8.77822 13.7576 17.8642 -40.1771 -16.3075 +354 2 12.2963 9.16979 15.1004 -1.36164 -11.5003 11.0357 +355 1 4.07044 15.2648 6.99086 -8.22484 -15.5272 10.3185 +356 2 3.65725 16.0904 6.74002 -9.77102 8.77549 -2.61135 +357 2 5.00026 15.4315 6.88928 20.0063 2.47059 -3.54324 +358 1 0.744606 8.73408 15.0763 0.0218964 -5.95646 -3.10884 +359 2 0.519262 9.66197 15.1074 -7.84082 12.7234 2.89932 +360 2 1.47025 8.73132 14.4431 5.87969 -4.51966 -2.6491 +361 1 12.9306 8.27919 10.1905 8.08936 2.40022 19.7343 +362 2 13.779 7.90886 9.87037 -9.22858 -4.32337 9.26771 +363 2 12.8604 8.07471 11.1624 7.69549 -2.50096 -25.1681 +364 1 15.3235 7.85492 3.5497 18.4153 32.411 -54.1913 +365 2 14.4745 7.6657 3.15314 -16.0822 -13.4855 9.94503 +366 2 15.5116 7.64082 4.44166 -12.2255 -21.7424 34.152 +367 1 17.2256 6.71185 18.6385 13.0601 3.46678 -1.24204 +368 2 16.7837 5.9846 0.423329 -10.4159 -11.046 2.92977 +369 2 16.5307 7.32814 18.3852 -6.78357 2.8142 -3.2779 +370 1 8.8964 6.96848 7.83902 16.0931 16.0227 -2.80611 +371 2 9.83265 7.28699 7.8278 -17.1093 -4.77101 0.707558 +372 2 8.79691 6.46408 8.64714 -0.939429 -8.3316 9.69843 +373 1 12.4084 0.523138 1.23768 -2.06115 0.0733923 -7.11266 +374 2 13.1872 0.998726 1.54472 7.23891 -2.91784 -1.02165 +375 2 12.4662 0.537618 0.274809 1.69654 -3.93261 2.5223 +376 1 5.65468 15.0902 14.5334 3.02676 -25.5773 -0.125585 +377 2 4.72407 15.1616 14.7961 0.127409 2.72757 -0.91443 +378 2 5.99013 15.9712 14.3886 3.52657 16.2654 -6.40367 +379 1 3.82399 6.39797 1.75512 3.78691 -6.14258 3.26006 +380 2 3.37829 7.15763 1.38654 -6.41374 16.3556 -5.84968 +381 2 3.97609 6.61981 2.67876 -1.82166 -0.0414506 2.69272 +382 1 3.91801 11.4637 12.3808 6.26728 1.11409 -8.60855 +383 2 4.78798 11.8777 12.4982 -7.30712 -3.21292 -1.54071 +384 2 3.30212 12.087 12.775 -5.64928 0.778082 5.20377 +385 1 5.29676 3.85177 15.8189 3.43828 -31.27 -8.27082 +386 2 6.03967 3.23378 15.6029 -11.8461 12.1043 0.727598 +387 2 5.68429 4.70341 15.931 13.0054 23.274 1.41344 +388 1 14.2193 10.1559 4.56622 -21.9238 17.9967 10.7876 +389 2 14.2923 9.81422 5.45847 5.67938 -3.41822 10.3914 +390 2 14.6614 9.51741 4.03067 14.2685 -12.4061 -15.9356 +391 1 7.6994 17.3598 9.13069 2.58566 -7.07749 -1.38218 +392 2 6.9688 17.7373 9.6086 -11.208 -1.02501 12.7072 +393 2 7.91331 18.0249 8.47917 9.78731 5.09099 -13.1281 +394 1 4.50671 14.5226 3.97805 12.528 -25.4608 -46.8355 +395 2 4.48015 15.4086 4.24602 -0.161492 47.21 12.2969 +396 2 4.35306 14.022 4.74858 -6.07017 -24.5156 30.0525 +397 1 14.1411 7.46132 15.8217 -22.5264 -9.25347 -2.17647 +398 2 14.9826 7.35759 15.4044 20.5288 -0.540355 -7.58788 +399 2 14.3421 7.83921 16.6731 3.72262 6.08742 11.7763 +400 1 2.98184 18.372 1.90579 -20.1648 -30.237 -17.2141 +401 2 2.43548 17.7555 1.32026 19.5303 24.385 16.7936 +402 2 2.33791 0.236975 2.41065 -5.95562 0.980031 -0.0237849 +403 1 7.99445 1.58502 4.53075 18.7977 0.504684 -14.6733 +404 2 7.48712 1.99417 3.8192 -9.17378 0.780153 1.87786 +405 2 8.88078 1.50473 4.13387 -7.12077 1.17171 10.2984 +406 1 2.41951 14.1599 17.7056 22.0207 15.2121 -4.13121 +407 2 1.68443 13.6195 17.9516 -15.3327 -12.8663 8.26013 +408 2 3.18525 13.6986 18.0793 5.57496 -0.0710026 -2.65101 +409 1 0.908587 1.85846 13.8858 -0.0793858 -1.94323 14.6669 +410 2 1.14821 1.59902 14.7928 -3.46921 3.66635 -7.67361 +411 2 18.5942 2.00299 13.9058 4.01903 -0.250224 -6.72878 +412 1 4.32702 0.129386 13.8829 -0.0770511 3.08332 3.55447 +413 2 5.24833 18.5067 13.8286 4.90059 -4.64875 -2.30826 +414 2 4.05486 18.5232 14.7746 -2.81766 -1.27361 1.32354 +415 1 7.27357 0.854459 18.3804 -15.3869 4.3045 -1.1218 +416 2 7.16992 0.518993 17.4624 3.36336 5.55626 15.3605 +417 2 6.40185 1.20099 18.6914 11.5657 -10.6186 -10.5297 +418 1 15.9542 18.4046 13.9208 -25.3022 5.029 -14.7602 +419 2 15.0075 18.5254 13.735 13.8644 -2.42428 -4.09563 +420 2 16.0061 18.5076 14.8614 8.67486 -1.51607 21.0166 +421 1 10.2392 4.55204 16.2801 10.7238 -8.25817 -3.6178 +422 2 11.196 4.37813 16.4864 -24.802 4.89259 -9.76699 +423 2 9.86858 3.73489 15.891 10.2726 5.88423 10.0044 +424 1 15.9238 17.7149 4.45644 2.75189 -23.1215 -12.8271 +425 2 16.5168 18.4535 4.47728 14.6813 18.6917 2.39924 +426 2 15.0936 18.0469 4.76398 -21.0845 8.87368 10.3462 +427 1 6.95648 17.503 13.9077 -51.9825 -4.38955 -3.71365 +428 2 7.39002 17.773 14.6913 25.8751 9.72049 29.5532 +429 2 7.60747 17.4983 13.2335 27.2317 -2.92469 -23.3456 +430 1 13.2071 6.48879 6.54043 12.3601 -8.29587 -18.0485 +431 2 14.1818 6.5258 6.42811 -17.7974 6.95191 3.55269 +432 2 12.8555 6.35956 5.62691 5.37067 1.68412 18.5111 +433 1 7.86742 2.30794 9.39626 -5.35093 5.07188 8.74379 +434 2 7.30782 2.2926 10.1983 5.67726 -4.12754 -5.74363 +435 2 7.33716 1.92062 8.69482 -5.03183 0.0809058 -6.36949 +436 1 15.2078 14.7586 13.7432 0.832397 -4.30074 -2.87903 +437 2 14.8858 14.9257 14.6258 -3.94452 3.16733 11.6107 +438 2 14.9517 15.5204 13.2236 -2.78606 2.09491 -5.66724 +439 1 9.4202 8.34719 3.8485 -22.8652 4.71801 -4.87246 +440 2 10.1988 8.89706 3.87201 15.3465 4.97444 3.28263 +441 2 9.69606 7.44575 4.01411 1.53448 -7.03017 -1.02937 +442 1 17.7384 13.5884 16.4052 -11.7067 -11.536 8.32036 +443 2 16.7673 13.5542 16.377 3.38001 -6.87595 1.27552 +444 2 17.9496 14.385 15.9274 3.88108 14.0768 -7.71607 +445 1 4.90559 10.5521 2.87839 21.3367 -20.8737 -11.4011 +446 2 5.623 10.1254 3.38432 -4.07258 6.62764 -8.01418 +447 2 4.62886 11.2624 3.4373 -4.18877 12.0113 9.86562 +448 1 3.72998 8.3995 9.96949 0.206562 0.552242 5.18998 +449 2 3.80623 9.33185 9.71276 -0.050758 -4.34606 1.0469 +450 2 3.86748 8.41721 10.9275 -4.36654 -3.13592 -2.04235 +451 1 15.965 6.95365 5.95266 -6.26742 1.66997 1.55481 +452 2 16.7698 7.37181 6.25298 11.0034 6.69643 7.83926 +453 2 16.2161 6.06091 5.70554 3.02292 -8.38979 0.185448 +454 1 15.1879 7.19538 9.00463 -16.574 -33.0638 16.9279 +455 2 15.9728 7.55664 9.38717 21.7076 13.0833 8.35481 +456 2 14.9649 7.65827 8.21955 0.87619 20.3483 -26.3308 +457 1 6.20656 12.8742 12.7233 -2.45823 6.18764 -5.3718 +458 2 6.79799 12.2543 13.1384 18.4055 -9.75357 3.10315 +459 2 6.13621 13.6122 13.3363 -4.91508 8.57981 5.63651 +460 1 12.128 4.53555 13.1062 -17.5662 -8.78193 22.9206 +461 2 12.3906 4.63486 14.0411 2.44404 0.930561 -9.75427 +462 2 11.3004 4.01263 13.1714 14.0583 8.15169 -11.9376 +463 1 11.4184 8.10098 7.95437 7.14359 -3.91624 -16.2991 +464 2 12.1028 7.60478 7.4673 -7.16754 1.39876 -0.578178 +465 2 11.8093 8.18067 8.82553 -2.79742 2.89488 8.77133 +466 1 17.0514 10.8651 7.58728 -24.1088 0.784299 26.3012 +467 2 17.8144 10.3384 7.41217 20.5663 -15.9736 -11.9321 +468 2 16.8601 11.4269 6.84052 2.19633 6.48519 -17.1676 +469 1 5.231 18.0993 10.8546 26.455 4.8965 -4.82813 +470 2 4.8195 17.6908 11.6007 -11.7048 -9.88744 14.1218 +471 2 4.63699 18.0004 10.1206 -18.4061 3.17503 -16.8763 +472 1 7.59767 17.4436 1.69759 5.72815 6.19172 -16.2775 +473 2 7.89477 16.6568 1.18579 0.971667 15.0969 7.35096 +474 2 7.65141 18.2352 1.10536 -4.88626 -20.2664 5.47735 +475 1 1.93145 12.9234 13.6206 5.60545 -3.12143 -21.3855 +476 2 1.4749 12.3281 14.2061 -8.56587 -7.9862 10.2726 +477 2 2.17547 13.6903 14.1341 4.19375 11.0678 7.71152 +478 1 9.43748 6.79443 14.8327 33.0335 -30.4644 -7.71462 +479 2 9.91196 6.01751 15.25 -19.5648 18.6507 -3.60269 +480 2 9.7502 6.76156 13.9011 -9.65438 10.9618 10.9707 +481 1 15.2831 4.34212 10.7772 21.179 15.7439 -2.01388 +482 2 16.2293 4.27243 10.5111 -19.8675 -5.23 11.4528 +483 2 15.2971 5.09975 11.4021 -5.00612 -14.3562 -6.14057 +484 1 11.351 6.2072 0.109577 23.6613 28.7979 6.66193 +485 2 11.4872 5.27024 0.0694097 -6.21323 -21.6319 -6.22108 +486 2 10.4676 6.44004 18.4761 -18.3883 -9.25121 -2.88973 +487 1 18.5357 11.4228 14.9398 26.7643 -26.8403 31.1109 +488 2 18.0597 11.723 14.1947 -18.2778 17.0129 -29.9513 +489 2 18.4532 12.1424 15.5699 -5.23995 5.81903 4.32114 +490 1 7.05668 9.28071 7.31234 -6.58466 7.4517 -4.55549 +491 2 6.71011 8.47084 7.6978 -4.31789 -6.13087 1.68327 +492 2 7.98804 9.13135 7.18438 15.6823 -2.37616 0.276954 +493 1 18.324 15.3331 12.2569 -7.46978 -1.64803 5.36971 +494 2 0.564477 15.5946 11.9899 10.9599 1.36641 -5.51497 +495 2 17.7284 15.6281 11.5548 0.957946 6.58656 -2.69515 +496 1 16.4958 4.38611 5.25998 2.69003 14.057 -30.634 +497 2 16.6253 3.88668 6.0538 7.32023 -9.57738 16.711 +498 2 17.3371 4.41488 4.75201 -4.14044 -1.60108 11.4247 +499 1 17.7073 3.15256 10.779 -3.63642 -2.40486 -9.15002 +500 2 18.6235 3.40441 10.9111 8.43018 2.88916 7.88185 +501 2 17.7389 2.35032 10.2471 -2.89329 -5.91517 0.580451 +502 1 12.2813 18.6401 10.1181 2.89516 -35.5496 -8.35074 +503 2 11.4703 0.383955 10.4005 -29.8535 10.9583 6.97968 +504 2 12.9196 0.674429 10.2218 25.4798 25.6209 2.989 +505 1 10.3974 9.74216 12.5073 0.112101 -17.0368 -3.21727 +506 2 11.1947 9.82557 13.039 4.39701 4.68697 5.66162 +507 2 10.3035 8.76836 12.4158 -2.37231 15.8308 -1.56525 +508 1 0.663588 2.73535 7.12598 -12.3374 1.53361 -6.62113 +509 2 0.367817 3.62684 7.37457 5.09588 -7.68469 3.80292 +510 2 0.956045 2.28157 7.92852 1.53616 1.67998 2.79736 +511 1 0.311147 15.2759 6.88171 -13.4592 45.4783 4.03261 +512 2 0.500617 15.614 7.76495 4.81164 -9.60864 4.06796 +513 2 0.558697 14.3764 6.88071 13.8097 -37.6199 -4.57419 +514 1 17.0548 6.97395 15.0744 4.20776 -1.94343 -1.58424 +515 2 17.8177 7.57453 14.9855 -5.12063 -2.20736 -0.0554095 +516 2 17.4111 6.17613 15.4934 -0.113823 0.922547 0.618491 +517 1 9.1503 12.5213 8.01319 -14.1189 2.82879 0.278945 +518 2 9.53356 11.9725 7.3299 10.3093 -11.5802 -1.96405 +519 2 8.24075 12.6139 7.71394 -0.988228 2.45183 6.21614 +520 1 1.17609 1.70844 2.83295 3.23913 -2.31621 -1.89882 +521 2 1.09855 2.22978 2.02752 -9.74566 -1.77621 -3.35395 +522 2 1.86202 2.13223 3.34238 5.26299 8.17365 10.1548 +523 1 4.09291 15.1504 9.8922 18.1507 -7.2721 -6.40054 +524 2 4.03036 15.1629 8.92399 -1.00826 2.87435 -0.463193 +525 2 4.99389 14.8146 10.0732 -8.74469 0.915467 -5.31212 +526 1 7.37772 2.25117 14.7222 3.22505 8.21162 1.39777 +527 2 7.09502 1.54536 14.1374 1.57311 -0.181539 -4.41158 +528 2 7.85635 2.90205 14.1691 -14.4419 -9.06063 9.37489 +529 1 18.4006 14.5833 2.15968 -9.78242 8.50711 -1.4388 +530 2 0.62994 14.8842 2.46282 -4.8788 5.17113 -0.292034 +531 2 17.7517 15.3351 2.17575 17.725 -12.6913 0.414249 +532 1 9.99197 2.68277 12.9223 -2.58103 11.7713 -8.17336 +533 2 9.96789 2.1685 12.101 0.346485 -5.49174 3.23624 +534 2 9.29748 3.35451 12.7936 3.47695 -5.23648 4.96996 +535 1 2.96299 8.91941 13.096 19.2939 -0.203164 0.561242 +536 2 3.4486 9.7527 12.8428 -15.067 -18.0348 7.07188 +537 2 3.65865 8.27445 13.3679 -12.9331 14.6867 -6.35999 +538 1 3.26147 8.578 3.77304 6.38222 5.3653 -9.36202 +539 2 3.78874 9.26676 3.32736 -9.65467 -7.00498 -1.39723 +540 2 3.24393 8.8647 4.68594 3.08129 -4.64857 6.90262 +541 1 5.77287 7.24333 8.61048 -1.78661 -5.00814 9.07462 +542 2 5.68022 6.28289 8.53661 4.0016 -1.85755 -4.86386 +543 2 5.00276 7.50215 9.14094 4.61323 4.45406 -2.92895 +544 1 14.8793 1.52937 1.85035 -12.7334 -14.0835 12.9397 +545 2 14.819 2.16152 2.5876 10.8144 6.55959 -13.4181 +546 2 15.5594 1.73936 1.19754 -2.84827 11.2594 2.6977 +547 1 8.5607 15.0611 0.725284 0.46926 -2.1008 2.83341 +548 2 9.29259 14.9147 1.35885 -7.99161 6.01774 -7.32206 +549 2 7.81927 14.5289 1.05772 1.7687 -2.35649 0.826934 +550 1 15.4921 1.3993 7.20702 14.746 2.01238 2.95597 +551 2 14.8484 0.891915 6.72418 -10.4472 -9.96976 -7.88743 +552 2 15.1077 2.27361 7.28199 -8.00989 7.94424 8.07076 +553 1 5.01058 12.9585 18.4386 -15.8567 -4.4202 8.08993 +554 2 5.4193 13.0053 0.667327 2.46468 -0.195888 1.58163 +555 2 5.59523 13.4446 17.8643 8.60291 1.11734 -4.66644 +556 1 15.4019 8.61725 18.0949 -10.0539 -8.80276 13.7753 +557 2 15.8344 9.23888 17.5182 6.53635 7.63687 -15.5634 +558 2 15.1418 9.16559 0.203922 1.58583 0.47418 3.18719 +559 1 12.0525 3.11208 18.2861 7.73999 -14.4321 9.61497 +560 2 12.4007 2.82569 0.495607 -5.57788 10.1171 1.38067 +561 2 12.4066 2.43321 17.7002 -1.56388 4.26076 -9.69121 +562 1 13.1688 12.6857 5.1494 7.31226 -7.20074 3.10637 +563 2 13.4985 11.8462 4.78426 1.65488 6.62932 1.41885 +564 2 13.3525 12.6203 6.1046 -3.90991 6.43934 -4.24709 +565 1 6.08926 7.21668 0.130178 -1.88627 11.2856 16.2629 +566 2 6.12641 8.19603 18.8427 -2.9512 -23.7133 -6.32338 +567 2 5.32645 6.95656 0.679872 3.54107 -2.60359 -10.7249 +568 1 17.6547 15.8703 14.9132 16.2429 2.82715 17.6162 +569 2 16.6953 15.9075 15.0555 4.78919 3.7515 -14.6122 +570 2 17.9345 15.7768 13.9856 -18.469 -1.14955 -2.42085 +571 1 13.1468 0.885591 16.7291 -10.7864 15.024 2.10847 +572 2 14.1008 0.813897 16.7431 10.5998 -4.62802 3.60151 +573 2 12.8375 18.6536 16.4909 -4.88764 -9.34618 2.57866 +574 1 10.8908 14.4992 7.43136 -2.2343 -7.03539 12.0134 +575 2 10.0835 14.2065 7.92308 22.5278 2.1252 -13.3834 +576 2 11.6003 13.8396 7.60224 -11.7269 11.3777 -3.99947 +577 1 17.6181 8.42363 2.12766 -11.9935 -3.6797 -6.77545 +578 2 16.7343 8.37762 2.55285 14.0369 1.72981 -7.6286 +579 2 17.5632 7.81953 1.35766 3.76606 6.32419 13.0143 +580 1 12.3929 7.83138 2.01819 4.71096 17.5308 0.40727 +581 2 12.1717 8.7272 1.7221 -1.13772 -2.1217 4.67191 +582 2 11.9464 7.25327 1.39471 0.282935 -6.68024 -6.10503 +583 1 12.0275 14.6478 10.4009 38.9809 -24.2439 -10.9711 +584 2 12.337 14.044 9.6932 -4.28518 13.1756 12.472 +585 2 11.1105 14.7441 10.2592 -43.0899 4.37787 -4.57767 +586 1 6.8265 6.93238 15.5327 -27.6581 -7.97269 5.64053 +587 2 7.73103 7.08984 15.3178 26.4357 1.09681 -7.32033 +588 2 6.59533 7.63547 16.1384 -2.46814 3.13878 5.80205 +589 1 7.96021 4.51991 13.281 5.98272 36.635 4.98876 +590 2 7.18773 4.72006 12.7149 7.22552 -5.34662 5.9239 +591 2 8.2239 5.40342 13.6709 -8.7699 -31.8396 -11.1478 +592 1 13.3799 12.1942 14.3144 0.413244 -2.26196 2.0512 +593 2 13.2473 11.2333 14.3131 -4.23433 1.2327 0.0241848 +594 2 13.7366 12.3802 13.4362 1.03232 3.06063 -1.77089 +595 1 14.6196 9.43974 7.2819 12.1284 19.1611 12.5008 +596 2 15.4631 9.9012 7.50833 -13.143 -10.3991 -7.78335 +597 2 13.9498 9.89967 7.80701 0.241302 -5.62146 -3.59828 +598 1 12.6688 16.8855 3.24635 -1.47445 -34.5545 -0.541717 +599 2 12.9124 17.3724 4.01195 4.0393 16.1159 25.6755 +600 2 12.6994 17.4999 2.53895 -2.71389 24.0914 -25.4271 +601 1 1.00064 7.12258 17.3474 25.8989 -13.4919 10.9638 +602 2 0.199171 6.81692 17.7654 -17.9333 6.12878 2.90109 +603 2 0.781412 7.72916 16.646 -4.92956 7.36441 -13.84 +604 1 12.947 4.88013 15.7213 -21.2986 7.3754 -0.931645 +605 2 13.7769 4.45629 15.8524 19.8874 -20.9291 -0.114876 +606 2 13.1805 5.80207 15.7513 2.74699 20.2475 2.05037 +607 1 2.36441 3.38825 5.1495 13.4973 -9.76059 -50.575 +608 2 1.87697 2.96062 5.81278 -27.3053 -18.1487 33.2377 +609 2 2.7907 4.09602 5.58982 16.1263 32.9476 11.4061 +610 1 8.23368 10.9868 13.6471 -16.5646 12.9957 -7.98974 +611 2 8.32411 10.9316 14.5895 -0.490848 -4.77914 16.6738 +612 2 9.07298 10.6867 13.3074 11.7511 -8.07538 -9.61613 +613 1 13.0107 1.52025 13.2616 -13.3177 -0.0328213 18.9383 +614 2 13.4383 1.61013 12.4179 13.267 -2.68379 -13.3373 +615 2 12.5185 2.34771 13.3673 3.11016 -7.04189 -1.75869 +616 1 6.59377 13.5764 2.15874 -7.12741 11.9903 -27.1264 +617 2 6.00679 13.9468 2.8128 -10.8754 6.0075 10.3445 +618 2 7.2163 13.0692 2.66145 9.56033 -10.8956 7.78491 +619 1 15.8548 6.42593 12.5881 24.8624 13.3217 16.2273 +620 2 16.4838 6.96617 12.0488 -16.1868 -9.65605 6.77151 +621 2 16.2214 6.49686 13.512 -7.09801 -2.27572 -23.2114 +622 1 16.7956 0.692247 9.54535 7.46915 17.7641 2.49637 +623 2 16.5452 18.5156 9.96298 -0.0131793 -20.516 -0.238231 +624 2 16.2976 0.789947 8.72228 -2.61192 -2.24486 -4.75056 +625 1 6.11318 11.627 8.27064 9.91462 44.2797 -2.20509 +626 2 5.35292 11.2978 8.70378 -29.3613 -6.33495 17.8965 +627 2 6.52877 10.8496 7.97791 23.4734 -34.8725 -13.0112 +628 1 2.81389 8.67751 0.381383 10.1752 -8.74242 -1.84173 +629 2 2.33278 8.32184 18.2713 -4.10181 -2.8979 1.44899 +630 2 2.25425 9.35695 0.757627 -6.74555 6.18422 5.10447 +631 1 10.1136 10.3815 6.5683 -3.97178 -1.84722 1.40214 +632 2 10.6776 9.73953 7.0164 -1.23094 -3.31757 4.86865 +633 2 10.3499 10.3203 5.64027 4.41826 3.29106 -4.73543 +634 1 6.84727 15.7748 6.6764 -14.7135 -11.7826 9.04786 +635 2 7.02398 16.1904 7.53289 5.38031 2.81892 -3.47781 +636 2 6.91879 16.4549 5.99719 9.07918 3.78678 -4.16926 +637 1 6.52182 12.8956 5.7943 0.541827 3.55761 1.99739 +638 2 6.55778 13.7774 6.19915 3.14226 -1.33255 -2.96851 +639 2 6.13082 12.3068 6.44859 -0.859963 5.03094 3.84811 +640 1 16.7567 12.5314 9.76383 -4.64367 0.23861 8.75508 +641 2 16.9908 11.8798 9.10281 -4.06168 -8.34407 -5.30318 +642 2 17.2898 13.2837 9.5332 2.7418 12.1851 0.697411 +643 1 6.23186 2.86269 2.75104 2.97881 8.48666 -1.38882 +644 2 6.52094 3.78037 2.52233 -11.0321 -17.6889 -1.77294 +645 2 5.63962 2.52843 2.04764 8.59188 6.36028 2.68011 +646 1 10.7835 3.03466 3.2504 -5.97107 -1.61798 -4.71292 +647 2 10.2628 3.82076 3.45136 1.61481 0.158577 0.983482 +648 2 10.306 2.59283 2.52669 4.73542 2.88639 2.9637 +ITEM: TIMESTEP +80 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.82629 6.70343 17.8553 -15.1071 8.15122 13.6853 +2 2 7.99416 6.85162 18.349 10.9787 -1.12299 -6.8679 +3 2 8.57507 6.09547 17.1643 3.5075 -8.11573 -6.04158 +4 1 0.137192 8.33532 6.74353 12.0191 -20.4001 -6.39938 +5 2 0.250097 8.10589 5.79669 -2.0008 6.10915 10.6578 +6 2 0.653601 7.63933 7.2162 -12.3825 18.3147 -3.0068 +7 1 8.60149 0.29664 6.93203 12.1667 -9.17994 12.1946 +8 2 9.52501 0.228788 6.64808 -5.75422 4.1152 -0.42095 +9 2 8.21226 0.977159 6.3883 -5.16274 6.48178 -7.47064 +10 1 6.50463 1.68869 11.7262 -16.2706 -7.92373 -2.85274 +11 2 5.9813 2.3145 12.2428 -2.71472 -2.47934 -1.80386 +12 2 5.86927 0.986784 11.4354 16.7384 10.0214 6.53226 +13 1 6.9131 5.55027 2.37535 3.77295 -5.39511 9.11334 +14 2 6.43692 5.84081 3.17655 -0.921031 3.98795 -14.1822 +15 2 6.69543 6.14979 1.6478 1.12895 -1.48609 4.32855 +16 1 16.196 10.2371 16.1388 -31.5516 2.77844 19.9706 +17 2 16.8915 10.3643 15.5412 37.4 6.14414 -23.2997 +18 2 15.8469 11.1288 16.3108 1.55641 -10.2432 -3.37881 +19 1 10.775 14.9631 2.31622 -5.5944 -0.094079 7.63582 +20 2 10.598 14.4521 3.12767 5.78422 3.02899 -5.84463 +21 2 11.1066 15.8146 2.64245 2.43259 -3.51347 -1.1859 +22 1 17.165 8.21001 10.8825 14.1674 -5.9779 -9.25967 +23 2 16.5809 8.83567 11.3092 -8.03296 12.2385 6.15632 +24 2 17.9797 8.71133 10.6858 -5.20793 -0.650283 -1.86008 +25 1 14.6097 15.9558 16.401 14.8916 -7.54315 9.24646 +26 2 13.6847 16.2494 16.4321 3.25844 -2.02272 0.00765398 +27 2 14.8063 15.4932 17.2527 -13.7355 5.39716 -16.4095 +28 1 12.117 13.3155 0.580411 -1.24587 -0.207976 3.78722 +29 2 11.7909 13.4576 18.3369 0.57388 -2.32058 -15.0609 +30 2 11.6242 13.9531 1.10951 4.78037 0.383607 7.31905 +31 1 9.34228 5.488 3.85121 53.6451 1.51077 14.3512 +32 2 8.91013 5.51861 4.6996 -19.4462 -5.34697 10.1126 +33 2 8.70488 5.4763 3.16894 -36.9473 -0.666442 -22.4182 +34 1 1.61615 3.95559 11.5848 -7.57046 15.5603 -11.9076 +35 2 1.66987 4.89506 11.8258 -4.51216 0.523906 3.16779 +36 2 2.10845 3.4705 12.2371 10.5178 -10.3797 12.993 +37 1 2.10284 6.89743 8.15957 -0.837321 -0.675751 7.8246 +38 2 2.47895 7.28827 8.96165 1.07034 3.30836 -6.30935 +39 2 2.071 5.95646 8.37348 -2.86121 -4.48577 -0.939591 +40 1 5.32433 4.44486 7.86972 -1.34052 23.2477 3.45796 +41 2 5.46877 3.5107 7.98026 -0.0649778 -19.4924 -5.7669 +42 2 4.70188 4.60713 7.1427 0.919422 -2.43856 3.29815 +43 1 3.32435 2.88678 17.4197 -1.88929 -9.6261 16.8991 +44 2 4.05816 3.29734 16.977 14.1471 9.33662 -16.3951 +45 2 2.86083 3.59453 17.8818 -3.32176 6.96255 1.50629 +46 1 7.47308 5.51417 6.17701 6.20604 7.73103 -29.885 +47 2 7.95124 6.07722 6.78768 5.01174 3.41934 10.0258 +48 2 7.09189 4.79949 6.66958 -7.20601 -9.71089 14.7057 +49 1 9.80158 6.99902 12.0223 -22.5784 -4.24274 -21.2019 +50 2 10.1069 6.1805 11.5916 -0.00510546 9.67372 7.70676 +51 2 9.03411 7.28611 11.4542 20.6129 -4.31213 14.2424 +52 1 14.1091 3.78361 8.12438 -15.7573 21.5912 -11.6445 +53 2 13.5201 4.50308 7.77049 18.8532 -19.0333 8.38218 +54 2 14.3457 4.04736 9.022 0.199067 1.13361 3.22772 +55 1 4.50215 17.2152 3.88612 2.87802 -1.37968 10.5361 +56 2 5.34021 17.6676 3.86593 13.8498 1.95887 5.68097 +57 2 3.97594 17.6789 3.24294 -11.45 0.485265 -14.6478 +58 1 16.2741 16.534 10.4726 -5.67102 -12.8311 -21.8814 +59 2 15.486 16.5615 11.0293 -1.33881 1.5325 0.205711 +60 2 15.9943 16.0074 9.67798 5.00326 13.1852 19.554 +61 1 1.98121 4.83276 0.125548 -2.90665 -21.863 0.561723 +62 2 2.62989 5.11603 0.769738 5.61812 10.8419 9.00632 +63 2 1.75087 5.59897 18.2498 0.950825 13.4626 -6.91806 +64 1 11.2654 13.2951 16.4195 -4.34554 -2.68737 -1.67212 +65 2 10.7681 12.4683 16.4833 0.87563 -1.05494 5.85319 +66 2 11.8765 13.1105 15.7039 6.19214 3.55339 -6.25188 +67 1 10.1028 10.9035 16.8331 17.2825 8.49241 1.71185 +68 2 10.5205 10.0327 16.7798 -0.767632 10.3686 4.9905 +69 2 9.17724 10.7556 16.7424 -24.4211 -4.37906 -2.41009 +70 1 11.8507 17.4827 13.4696 7.63981 7.03239 -1.88788 +71 2 12.509 16.94 12.9947 -8.02315 8.08552 1.57387 +72 2 12.1795 18.4053 13.408 -3.08283 -9.25718 -0.840972 +73 1 6.44601 9.4433 12.2773 8.37995 -15.986 -34.1351 +74 2 7.00514 9.1357 11.5138 -12.9725 10.8563 23.5312 +75 2 7.03346 9.94503 12.8365 5.04668 8.97956 7.26084 +76 1 16.2979 12.8575 2.71922 -11.7369 16.949 2.19382 +77 2 17.1652 13.221 2.45954 -10.8006 -1.31331 4.0939 +78 2 15.6758 13.6404 2.78783 18.0783 -23.2667 -2.52892 +79 1 0.707968 12.7192 5.87585 -9.46746 -3.17244 -7.34712 +80 2 1.05314 12.7932 4.98248 12.8843 -1.39545 -4.60697 +81 2 18.4375 12.4692 5.68303 -3.12969 3.97578 10.4064 +82 1 5.29671 16.347 18.4316 -9.43352 6.10902 0.949816 +83 2 5.62099 15.5668 17.9615 5.22561 3.70018 3.69326 +84 2 5.92538 16.5961 0.477291 0.486221 -4.47534 -1.04063 +85 1 0.707184 7.70367 4.119 -51.5024 -35.8612 26.1825 +86 2 0.14378 7.97362 3.40377 -12.5647 4.97441 -12.5535 +87 2 1.50957 8.08535 3.91273 65.7491 26.1316 -14.6887 +88 1 3.20348 9.03456 6.50534 -36.9666 27.611 -24.7826 +89 2 3.63112 8.56754 7.174 27.0077 -25.2244 35.3222 +90 2 2.25579 8.96355 6.72902 9.17057 2.1904 -6.46933 +91 1 7.27937 10.3761 16.2413 -0.230914 -4.48303 6.76598 +92 2 6.52755 10.9587 16.1419 -2.56448 5.11938 -3.06937 +93 2 7.11485 9.96393 17.0986 -0.495486 0.80288 1.59662 +94 1 11.0332 0.910989 5.0177 -6.88619 -3.17881 -8.23488 +95 2 10.972 1.75479 4.54866 7.92386 3.49104 7.17877 +96 2 10.6826 0.325395 4.32946 5.79259 -4.26916 6.55693 +97 1 4.2654 2.89302 13.1773 0.694211 20.6748 -2.64105 +98 2 4.39238 3.45448 13.9576 1.0821 -9.7456 0.782255 +99 2 4.16489 1.98946 13.4871 -0.702651 -10.6992 3.24412 +100 1 8.43419 10.272 1.79599 3.30535 -21.7188 -14.6566 +101 2 8.19585 10.8779 2.48837 0.0509316 11.2873 19.613 +102 2 8.53541 9.39344 2.20281 2.46081 9.96427 2.84146 +103 1 10.2486 1.68186 15.4597 -14.9494 5.38019 -3.47887 +104 2 11.0964 1.37036 15.7536 17.388 -0.916576 -1.92962 +105 2 10.2694 1.89097 14.5087 2.57313 -1.10767 6.05091 +106 1 2.6143 12.7739 7.92246 0.947228 -0.997667 -1.9326 +107 2 3.16975 13.4683 7.54148 -0.729705 2.73148 -0.490338 +108 2 1.96608 12.5591 7.23618 1.36975 0.244975 0.56737 +109 1 3.86268 11.7535 5.00307 -14.4028 -3.16999 8.33757 +110 2 3.70976 11.1475 5.74815 1.12966 3.67823 -8.44516 +111 2 3.06255 11.7297 4.44022 7.7842 4.67892 9.37694 +112 1 6.76061 14.5167 16.9537 -0.888094 -7.58336 -2.84579 +113 2 7.48488 15.1306 17.0914 4.64858 -1.1877 -1.93173 +114 2 6.56705 14.5225 16.0035 -2.02875 6.77169 3.29706 +115 1 14.2034 14.5245 3.20058 -0.0398844 -12.3077 5.38397 +116 2 13.8793 15.4221 3.34301 -5.62621 -2.27359 -1.58508 +117 2 13.7959 13.9448 3.87781 2.42748 11.415 -6.18352 +118 1 8.70505 18.0887 16.0942 -64.5065 -8.09898 -3.91687 +119 2 9.21396 17.4083 16.5058 25.0639 -11.349 2.42178 +120 2 9.16407 0.206988 15.7928 30.835 22.2192 -2.21878 +121 1 4.63692 1.68417 4.88655 37.1566 -9.63698 -3.58798 +122 2 3.87701 2.22405 4.82391 -30.2785 19.7734 3.84799 +123 2 5.28246 2.1077 4.29595 -5.87377 -5.36693 3.35208 +124 1 15.0131 12.6297 16.4887 -20.293 3.22713 36.7225 +125 2 14.5244 12.6173 17.3484 21.3151 5.53737 -15.2497 +126 2 14.2857 12.586 15.869 -0.208138 -0.973548 -24.0506 +127 1 15.729 18.4304 16.8576 -8.95075 23.4819 -17.3869 +128 2 16.2245 18.5231 17.6612 15.7889 -2.20706 14.0604 +129 2 15.4698 17.5226 16.786 -7.06215 -23.0828 1.02158 +130 1 1.394 1.31209 16.6703 -16.8241 -3.16738 2.04331 +131 2 2.15084 1.87826 16.8449 0.715689 -4.34048 -2.49358 +132 2 0.715561 1.66179 17.2756 6.00571 -5.18273 -5.07353 +133 1 18.2252 4.3402 15.9772 -8.55569 -2.73 -13.6324 +134 2 17.823 3.76125 15.3072 5.10239 5.23383 8.49054 +135 2 0.492866 4.4785 15.7127 2.39871 -0.864238 1.29175 +136 1 12.1265 17.032 16.1255 -25.5416 -7.58495 15.967 +137 2 11.3669 16.5924 16.5691 16.6277 5.86514 -1.80192 +138 2 11.8242 17.0598 15.2127 8.00105 4.8532 -10.0676 +139 1 16.1291 2.68344 18.211 0.375456 -13.3929 15.5569 +140 2 15.6138 3.3874 18.6109 -0.098248 15.4546 -4.83257 +141 2 15.8549 2.61026 17.3068 -10.5356 1.78345 -20.9571 +142 1 6.60182 13.7939 10.068 9.2492 3.65708 4.18485 +143 2 6.57275 13.4224 10.9661 -3.78941 -3.14938 -5.19226 +144 2 6.71396 13.0652 9.44214 -7.17216 -3.95227 2.85982 +145 1 10.1302 18.5571 2.70452 28.7428 2.61674 -1.08827 +146 2 10.6588 0.134354 1.90491 -8.77267 0.774664 16.1596 +147 2 9.28539 18.2699 2.40893 -22.5926 -9.32297 -10.0302 +148 1 3.0625 17.7033 6.15366 -32.6923 -3.28618 14.6113 +149 2 2.13754 17.6931 5.7562 38.9757 -0.864197 5.33283 +150 2 3.7049 17.7316 5.44436 -0.964713 0.371031 -13.1926 +151 1 12.6087 16.7853 7.93012 21.3772 -3.32102 -23.3093 +152 2 11.8409 16.2517 7.71322 -11.0279 -6.8961 6.738 +153 2 12.4183 17.3739 8.65053 -14.1479 13.0972 16.1976 +154 1 14.9031 15.2939 8.2802 -30.4011 23.5185 11.3145 +155 2 14.1656 15.9721 8.20757 23.4522 -23.8051 0.0341398 +156 2 15.3634 15.3182 7.4362 3.9964 4.48103 -1.46252 +157 1 17.8706 18.2596 0.245663 2.0948 -17.0514 -11.0411 +158 2 18.6148 17.6985 18.5349 -15.5847 20.6608 16.06 +159 2 18.229 0.448391 0.574358 6.37924 -1.254 -0.87753 +160 1 0.806491 10.487 1.42673 -7.2326 -9.98023 10.4462 +161 2 -0.00161399 9.98055 1.66044 10.6613 4.25192 -4.69396 +162 2 0.557346 11.1929 0.820979 -4.09494 2.43397 -4.83249 +163 1 1.83456 12.2686 3.29043 -8.34448 2.57963 -8.45001 +164 2 1.36787 11.5875 2.7525 13.033 10.6511 2.37549 +165 2 2.15971 12.967 2.6794 -8.27007 -10.3927 7.15994 +166 1 0.688934 17.2807 4.96532 -1.28513 13.5074 -14.6034 +167 2 -0.0176841 17.9487 5.11769 8.40666 -17.1979 3.35047 +168 2 0.596617 16.4414 5.43231 -12.6974 4.79178 9.39957 +169 1 1.09014 0.907525 9.3383 6.29421 1.3921 30.3575 +170 2 1.25758 0.656293 10.2983 -10.9635 5.07818 -25.2558 +171 2 0.281108 0.475301 9.05696 -4.67463 -4.0945 4.23309 +172 1 16.7684 2.39691 13.3495 9.61769 42.5491 2.72371 +173 2 16.904 2.78957 12.4595 -0.731435 -13.0756 10.2936 +174 2 16.527 1.48948 13.2642 -5.98641 -27.7824 -4.48506 +175 1 2.71373 15.9459 12.053 -3.75115 0.267025 20.4445 +176 2 2.98439 15.5717 12.9162 -2.14108 4.62523 -16.3505 +177 2 3.30112 15.6057 11.3695 4.80572 -2.00813 -1.58569 +178 1 16.3912 15.5658 6.1364 -18.5193 -23.7813 -1.39285 +179 2 17.3153 15.4712 6.31079 23.2449 0.130836 8.54259 +180 2 16.3263 16.278 5.5153 -3.20698 17.7917 -15.4301 +181 1 5.73039 5.21537 11.7967 -2.24013 5.33831 8.85226 +182 2 5.58704 6.03693 12.3192 -1.36073 -15.5687 -10.3459 +183 2 5.0707 4.59019 12.1393 4.45693 0.898588 -6.68224 +184 1 15.134 4.90094 0.781902 20.2218 -12.3751 4.08616 +185 2 14.9115 4.68422 1.69179 -1.28767 -2.72314 10.4735 +186 2 14.3889 5.35469 0.437757 -23.5901 14.4279 -10.7703 +187 1 16.3592 16.4594 1.89384 25.1746 19.6936 -18.9686 +188 2 16.2469 16.8 2.79117 -6.86302 3.67352 0.481682 +189 2 16.829 17.1783 1.36994 -16.7874 -21.2348 17.437 +190 1 0.175681 4.85349 3.94905 -38.6563 1.2533 -4.07114 +191 2 0.373462 5.78529 3.89581 11.5619 13.3417 2.94095 +192 2 0.969717 4.36237 4.02266 30.2668 -11.0427 7.4994 +193 1 2.99204 15.0813 15.1763 -0.305205 14.4793 -34.7595 +194 2 2.88713 14.6595 16.0135 -9.94348 -6.29569 26.5741 +195 2 2.4481 15.8945 15.1967 6.07768 -3.34342 6.9782 +196 1 1.12287 14.6661 9.5226 42.1359 23.511 16.8308 +197 2 2.04871 14.8527 9.88052 -40.3465 -4.39318 -17.9218 +198 2 1.08708 13.7187 9.50981 -4.88478 -15.9854 1.2011 +199 1 13.5299 16.5144 11.5405 11.2356 18.9117 4.33104 +200 2 13.1159 17.2557 11.0661 2.81218 -0.6798 2.92705 +201 2 13.1037 15.7572 11.1579 -10.8238 -16.1215 -4.14744 +202 1 4.70977 1.52963 0.718559 3.58248 -24.4192 11.8527 +203 2 4.08939 1.89433 0.0933404 -5.33693 14.3563 -9.66083 +204 2 4.20955 0.796838 1.1277 3.32575 8.01941 1.68952 +205 1 1.50238 18.6141 11.9042 -1.38031 13.5472 16.8753 +206 2 1.45658 0.425239 12.7856 -0.241625 -6.75063 -24.7438 +207 2 2.14944 17.9089 11.9973 -1.06457 -6.06855 3.15913 +208 1 11.4462 10.1354 4.10554 -27.8103 0.519562 13.0103 +209 2 11.5399 10.6236 3.29381 1.04561 4.25273 -17.1067 +210 2 12.3232 9.96387 4.39943 30.3669 -4.33072 3.08727 +211 1 8.16113 12.1728 3.80004 4.97071 -3.14572 14.2587 +212 2 8.9952 12.5305 4.11747 11.4774 1.91239 -11.4095 +213 2 7.64202 12.24 4.61417 -11.8418 -2.63078 -6.07404 +214 1 14.5844 4.03291 3.36716 -4.11232 -3.55002 -24.3582 +215 2 15.2517 4.33672 3.97304 10.7234 0.0718586 14.5399 +216 2 13.7453 4.32617 3.71649 -8.9869 4.72015 4.68372 +217 1 5.72064 1.64489 7.5839 32.9059 28.6425 0.0988457 +218 2 5.06921 1.12259 7.98588 -34.2591 -28.2453 24.4599 +219 2 5.39575 1.74393 6.6993 -3.28926 -2.3453 -25.2911 +220 1 17.8815 1.07824 4.83341 -4.77439 -8.44394 -0.469265 +221 2 18.4195 1.29399 4.06103 3.32925 4.9906 2.38586 +222 2 18.1973 1.60106 5.58304 1.56226 2.04575 -0.708791 +223 1 6.854 9.3046 4.53528 10.3956 -9.62802 3.27507 +224 2 6.69426 9.36632 5.492 2.76918 3.19153 -6.51095 +225 2 7.80605 9.0738 4.45229 -13.5827 1.70924 -0.808399 +226 1 2.59539 14.8276 2.04954 -21.4179 -5.20739 -34.911 +227 2 3.34516 14.7063 2.60932 22.2061 -1.352 15.1427 +228 2 2.90646 14.7931 1.11821 -3.29515 2.22824 22.2692 +229 1 17.3057 12.9587 13.1574 -14.3584 11.8265 -1.68619 +230 2 16.4238 13.3017 13.4505 21.6076 -1.54195 -11.2195 +231 2 17.8123 13.7306 12.814 -13.7958 -9.76612 7.37248 +232 1 14.8715 10.5568 1.52593 -13.8049 33.9422 19.399 +233 2 15.3968 11.3309 1.89043 -12.48 -24.7346 -11.1652 +234 2 13.9264 10.776 1.72699 26.333 -7.21409 -8.066 +235 1 5.65075 6.69227 4.53589 -1.16643 0.470211 -4.08107 +236 2 5.90168 7.60385 4.33311 1.92457 3.57872 5.04239 +237 2 6.31691 6.35225 5.15026 1.24698 1.28263 2.78678 +238 1 8.00933 8.29789 10.2803 -8.03608 2.46456 2.45807 +239 2 8.54459 8.86115 9.67988 -10.051 -7.82575 5.32423 +240 2 7.18397 7.98917 9.84875 17.8376 0.213066 -8.74409 +241 1 13.4452 18.4811 5.71348 30.3006 1.0471 -14.1486 +242 2 12.642 0.299737 5.48582 -19.0854 8.92614 -0.688815 +243 2 13.1967 17.7426 6.25238 -10.7462 -10.7439 19.4962 +244 1 -0.0119027 2.59488 0.354931 35.8038 -39.8932 13.3955 +245 2 17.7273 2.51611 0.10594 -24.5443 11.4005 -8.19311 +246 2 0.27212 3.48779 0.285479 3.99253 30.2779 -6.4317 +247 1 12.849 10.869 9.75158 -6.21929 20.5855 -7.88953 +248 2 11.8713 10.9784 9.78619 15.6811 -13.8069 -0.457669 +249 2 13.0615 9.92753 9.83861 -13.7986 2.36182 2.76964 +250 1 0.623186 12.214 11.083 4.78072 12.4497 9.66308 +251 2 18.3291 12.2937 11.2784 -7.07035 -2.86266 -6.1852 +252 2 1.03568 12.566 11.8864 5.16139 -3.44089 -5.05626 +253 1 5.24317 7.35288 13.329 16.5645 10.6427 9.86574 +254 2 5.81232 8.06371 12.9598 -16.2044 -6.02954 3.80806 +255 2 5.63373 7.21351 14.2126 -3.74153 -4.80134 -10.81 +256 1 1.17457 6.8033 11.9036 -23.8679 10.4664 -9.71638 +257 2 0.289623 7.06715 11.5324 26.398 -8.64759 11.7652 +258 2 1.56564 7.61974 12.2537 0.753648 -2.9175 -1.70229 +259 1 15.4919 9.76734 12.3795 0.0614124 -7.36309 3.05776 +260 2 15.0846 10.6319 12.2391 7.36463 -2.83561 -3.47144 +261 2 15.8873 9.82027 13.2467 -0.105969 -0.524429 6.2821 +262 1 16.5022 12.5635 5.51418 5.92626 -4.93161 -13.1981 +263 2 16.3002 13.4761 5.69188 -2.75562 16.3616 9.80459 +264 2 16.3759 12.5305 4.55079 1.66896 -8.7704 1.12914 +265 1 6.31756 9.85145 0.122373 -12.0354 8.37982 6.54531 +266 2 5.4699 10.2439 0.423151 12.3884 -4.45977 -3.2374 +267 2 6.98984 10.1338 0.758446 2.49067 2.04662 0.271789 +268 1 12.1918 6.08954 4.01066 -16.388 -25.9861 2.6766 +269 2 12.1912 6.72626 3.29268 0.559249 7.6643 3.09763 +270 2 11.3251 5.63233 3.94387 14.2823 13.1494 2.08097 +271 1 0.332379 12.8663 0.0441745 0.0508304 2.00456 8.93046 +272 2 18.9019 13.5185 0.756349 -7.27218 -2.99587 0.981784 +273 2 18.3327 13.1573 18.0278 2.80865 -1.79272 -4.8195 +274 1 3.54313 0.0443203 8.66238 11.9606 -6.13667 -3.48184 +275 2 3.32458 18.1774 7.87344 8.237 1.02812 -5.83338 +276 2 2.68777 0.391851 8.89446 -8.31408 9.03305 4.42594 +277 1 7.44404 17.5122 4.49167 0.119683 3.6114 3.91179 +278 2 7.85567 18.3869 4.65486 -14.0238 -13.6963 -7.23825 +279 2 7.39901 17.3877 3.53399 5.58618 2.96743 1.37553 +280 1 9.26713 17.153 12.2094 -20.2295 17.8608 7.81194 +281 2 9.28392 16.3133 11.7674 1.3049 -15.888 -12.5165 +282 2 10.076 17.208 12.7094 15.0452 0.291548 7.10451 +283 1 13.4068 13.0832 7.92217 -6.10698 -2.73533 15.5952 +284 2 13.4694 12.4257 8.66119 -0.459118 13.24 -15.7611 +285 2 13.8946 13.8972 8.17425 4.86633 -17.7849 -1.17812 +286 1 14.7977 2.95386 15.4326 21.7471 11.1646 11.1554 +287 2 14.1505 2.32893 15.1446 -13.9872 -17.9607 -8.38755 +288 2 15.4352 3.02911 14.7173 3.23846 -4.77681 -7.04868 +289 1 9.91022 15.6467 16.9338 -7.88269 11.4297 -3.43074 +290 2 10.0979 14.7902 16.532 6.40878 -6.10819 3.84543 +291 2 9.43747 15.4751 17.7557 1.6004 -7.26983 6.6271 +292 1 11.2148 8.51865 16.6243 -9.14606 -19.2231 -14.9185 +293 2 10.4285 8.06123 16.2547 13.8022 0.848227 5.21642 +294 2 11.6642 7.88268 17.1928 -1.33785 -0.880144 3.29074 +295 1 3.96477 18.2022 16.8388 0.151724 27.8243 14.0652 +296 2 4.47646 17.6367 17.4198 3.54357 -14.0579 0.0762873 +297 2 4.08749 0.446059 17.2373 -6.51294 -16.617 -15.0442 +298 1 2.23636 4.23466 8.90617 11.6474 4.96614 0.176633 +299 2 3.18727 4.06881 8.84702 -5.0902 0.586039 -2.82984 +300 2 2.03755 4.18072 9.84669 -2.61694 -5.47133 1.10155 +301 1 9.89683 10.3797 9.78633 12.6385 -21.4053 -24.2531 +302 2 9.49137 11.1552 9.42946 -10.1833 20.5571 -3.63947 +303 2 9.86232 10.3926 10.7266 0.554165 3.61624 28.8421 +304 1 9.72109 0.91625 10.832 13.6195 9.02414 1.59857 +305 2 9.21789 0.206273 11.2536 -3.38139 -4.49977 -6.76529 +306 2 9.17946 1.37162 10.1615 -3.40595 -8.11879 6.74876 +307 1 9.15707 15.1255 10.1914 20.6551 -3.22149 9.33909 +308 2 9.01609 15.916 9.68312 -8.41387 13.877 -8.61246 +309 2 8.34011 14.6408 10.1195 -14.233 -7.19689 -0.719266 +310 1 0.808146 9.70808 10.2086 23.84 -38.9856 -20.0319 +311 2 0.930598 10.6496 10.3444 5.65872 6.03362 4.8682 +312 2 1.64643 9.29884 9.83207 -32.5144 23.6532 16.8406 +313 1 17.0698 4.80337 8.05752 27.8638 -35.1931 -3.66362 +314 2 16.2966 5.30586 8.21629 -27.2809 18.9512 9.97555 +315 2 16.9993 3.9693 8.55928 -0.62818 15.8913 -5.61459 +316 1 14.8223 14.6574 0.153467 -11.4546 -14.4551 -9.90243 +317 2 15.436 15.0274 0.766448 14.8773 15.1477 17.5942 +318 2 14.121 14.2916 0.705806 -3.92817 0.026116 -2.07816 +319 1 3.85634 11.0156 9.57857 3.75671 2.20251 0.903354 +320 2 3.89754 11.3203 10.4983 -5.37308 2.01291 2.42961 +321 2 3.35837 11.6719 9.06911 -6.8083 1.73507 0.204751 +322 1 11.3728 10.7464 1.42992 33.2497 -4.81825 9.44885 +323 2 11.5281 11.6383 1.10055 0.915848 5.55374 -4.33141 +324 2 10.4426 10.6155 1.47257 -31.1398 -0.627116 -5.41705 +325 1 13.1828 7.20447 12.6676 -0.0478479 -14.2604 -0.4669 +326 2 14.1298 6.99811 12.5505 -7.76827 -0.67018 4.43892 +327 2 12.735 6.32848 12.7534 7.45412 15.7346 -2.47341 +328 1 9.63194 1.91441 0.890304 3.16134 4.31897 -8.70512 +329 2 8.77158 1.63222 0.526893 10.8452 7.48256 0.350857 +330 2 10.2032 2.19638 0.151243 -8.90992 -2.48069 6.74103 +331 1 10.6318 13.4626 4.55882 -11.5056 -1.99047 12.5083 +332 2 11.4876 13.0509 4.71851 7.47615 -1.29416 -2.63952 +333 2 10.4232 13.8662 5.41293 0.691023 4.41994 -1.81408 +334 1 14.5517 1.66181 10.9802 -11.5576 12.9 9.45395 +335 2 15.3776 1.3055 10.6442 8.04202 2.4344 -3.19562 +336 2 14.6907 2.6148 11.169 4.38713 -8.31284 -15.1855 +337 1 14.4901 12.0498 11.5809 -31.454 -4.77499 25.6083 +338 2 15.091 12.4736 11.0015 28.7023 12.1919 -21.8177 +339 2 13.8321 11.6274 11.0162 -1.74489 3.16984 -4.97875 +340 1 8.17369 5.13537 9.87952 -12.8505 7.96449 12.3464 +341 2 7.30162 5.126 10.3345 14.626 0.500686 -8.94194 +342 2 8.32701 4.24033 9.57061 -3.03583 -8.79147 -1.32617 +343 1 1.61182 16.9829 18.4557 19.3906 15.8485 -25.2691 +344 2 2.09739 17.4464 17.7224 -9.17701 -12.9822 18.3353 +345 2 1.80792 16.0477 18.3234 -0.14796 -4.92565 -1.79656 +346 1 1.43858 17.3769 15.3174 -8.9259 8.94647 7.52005 +347 2 1.45812 18.1702 15.9147 -6.93156 -15.9408 -17.1792 +348 2 0.507347 17.0882 15.1685 14.4449 8.30676 8.33907 +349 1 3.5257 5.78471 6.06613 -3.39677 -13.3058 1.89016 +350 2 2.9753 6.46227 6.46115 -3.38454 1.41808 7.55669 +351 2 4.15739 6.26663 5.53865 9.2569 4.30143 -12.1591 +352 1 12.629 9.51298 14.2604 -9.77978 19.3775 3.35531 +353 2 12.9437 8.76225 13.7938 15.2815 -22.6591 -22.819 +354 2 12.3447 9.10922 15.0729 -6.56341 1.36458 18.6396 +355 1 4.0928 15.2431 7.0497 -2.25109 -22.7738 13.7055 +356 2 3.66448 16.0653 6.81785 -2.80743 13.3283 -7.68 +357 2 5.04695 15.3859 7.01583 3.36741 6.66555 -6.63338 +358 1 0.780201 8.79903 15.0924 -4.1065 -28.223 6.26572 +359 2 0.548696 9.72105 15.1288 -1.34907 18.7642 -4.10325 +360 2 1.5752 8.72345 14.5481 -0.207921 7.22304 -3.82448 +361 1 12.9286 8.29499 10.1476 33.3114 -28.911 32.5654 +362 2 13.7554 7.80683 9.90421 -18.1809 10.2081 -7.43875 +363 2 12.9042 8.10572 11.1188 -9.83308 4.93442 -19.3471 +364 1 15.2998 7.93844 3.50826 -21.0939 -7.00262 -11.8412 +365 2 14.4558 7.58878 3.24395 -11.6977 10.4201 -28.099 +366 2 15.3831 7.3862 4.26257 30.2163 -1.92794 33.2483 +367 1 17.18 6.71526 18.6425 -0.133844 12.8911 -12.7702 +368 2 16.7451 5.93694 0.322596 -6.25651 -15.7248 7.28694 +369 2 16.4413 7.25778 18.3094 9.30548 1.37884 5.01187 +370 1 8.9084 6.99396 7.88573 -0.881002 2.32267 0.0260346 +371 2 9.83584 7.2627 7.79742 -0.0847644 -0.13812 3.11438 +372 2 8.83558 6.46246 8.69404 -0.0294368 0.694249 -1.22754 +373 1 12.437 0.501834 1.22358 -0.716997 -8.58934 -9.29719 +374 2 13.1312 1.05983 1.5788 8.89791 0.478791 5.50433 +375 2 12.732 0.307907 0.326573 -3.73597 1.67796 1.81541 +376 1 5.69458 15.0516 14.5143 3.69591 -14.2553 -4.53333 +377 2 4.76954 15.0969 14.776 -8.31751 1.66253 0.63197 +378 2 5.95328 15.9515 14.3109 5.80865 11.3045 -3.56535 +379 1 3.78081 6.42509 1.75203 4.2348 -8.30075 -4.29513 +380 2 3.33672 7.18396 1.37288 -3.60544 13.0853 -6.67388 +381 2 3.84967 6.63422 2.68491 0.545892 0.795555 6.86444 +382 1 3.88792 11.3989 12.3546 13.0971 -5.24635 -8.64578 +383 2 4.74838 11.8202 12.5261 -6.66532 -1.91753 0.168546 +384 2 3.23677 11.927 12.8169 -5.64663 9.70313 4.55872 +385 1 5.30252 3.85246 15.7701 3.45242 11.6571 4.53522 +386 2 6.06202 3.27771 15.61 2.30678 -4.65184 -5.35711 +387 2 5.68598 4.72788 15.9368 -2.89319 -4.23448 -3.12102 +388 1 14.1378 10.1309 4.62741 -6.40911 2.93718 -21.1253 +389 2 14.285 9.82325 5.50803 7.98673 -9.05047 24.7099 +390 2 14.6717 9.53242 4.07811 -2.84302 6.29722 1.17771 +391 1 7.65634 17.3346 9.10408 10.3132 -24.7491 -1.74792 +392 2 7.07794 17.6856 9.78277 -9.16436 8.21537 0.604828 +393 2 7.96278 18.0151 8.50473 -0.553145 15.1908 -4.94918 +394 1 4.52232 14.5173 3.95827 12.1345 -25.6108 -47.7046 +395 2 4.42958 15.3956 4.25649 -1.76895 36.8878 18.7873 +396 2 4.4098 13.9051 4.66351 -3.8607 -15.3504 25.5968 +397 1 14.1258 7.45828 15.8364 -6.23365 -6.73609 3.75314 +398 2 14.9302 7.39167 15.3277 7.57838 -0.290505 -5.08612 +399 2 14.4287 7.78058 16.69 -2.09073 5.34234 4.78248 +400 1 2.95098 18.3751 1.91859 -29.5535 -1.78839 -16.8987 +401 2 2.45071 17.8858 1.20736 17.1758 4.42604 21.0133 +402 2 2.2449 0.246547 2.36374 11.8246 -5.6794 -7.15496 +403 1 7.99154 1.5773 4.49846 30.6245 -5.45524 3.73918 +404 2 7.42382 1.97686 3.83614 -1.09908 5.00667 -8.45405 +405 2 8.90683 1.55308 4.13454 -22.7919 6.21994 3.05753 +406 1 2.44336 14.1732 17.7263 2.89693 8.8065 2.99283 +407 2 1.80182 13.5359 18.0713 -0.462046 0.279758 -5.24045 +408 2 3.30188 13.814 17.96 10.6791 -8.66055 4.12847 +409 1 0.94217 1.90899 13.8934 13.5408 -1.52741 -1.05885 +410 2 1.19747 1.57322 14.7589 -4.95142 3.16298 5.50662 +411 2 18.6373 2.03702 13.8998 -8.7871 -0.483879 -2.02084 +412 1 4.30938 0.151078 13.8855 7.43827 7.09651 -9.2822 +413 2 5.23906 18.5299 13.9426 -3.76642 -3.92995 -1.86801 +414 2 3.88869 18.4591 14.673 -3.49259 -4.03929 12.0029 +415 1 7.32054 0.93366 18.4163 -33.3446 -10.4004 5.92831 +416 2 7.32153 0.654144 17.4916 5.03052 -1.00997 0.0977128 +417 2 6.36163 0.937686 18.6972 26.0729 9.45288 -6.86634 +418 1 15.8933 18.4156 13.9169 -22.9956 8.12347 -47.8741 +419 2 14.9583 18.5802 13.6337 24.0447 -6.26997 16.1472 +420 2 15.9487 18.2637 14.8423 -3.56821 2.97357 29.888 +421 1 10.2651 4.57121 16.2688 1.93413 -35.0494 -13.7078 +422 2 11.2092 4.46181 16.4883 -7.31309 8.12251 -3.69007 +423 2 10.0229 3.6678 15.9192 2.49448 27.3645 14.4368 +424 1 15.9059 17.707 4.46041 -10.2591 -26.7612 -3.24664 +425 2 16.489 18.4443 4.44561 19.3223 26.1038 4.21423 +426 2 15.1093 18.0276 4.88994 -9.23113 3.77657 -1.20249 +427 1 6.91304 17.5561 13.9404 -32.5423 1.81832 8.8205 +428 2 7.45718 17.7359 14.6891 13.6263 3.56972 27.349 +429 2 7.55119 17.4736 13.2627 22.9256 -5.60471 -32.7019 +430 1 13.1887 6.46821 6.52506 2.14134 -6.99498 -16.9539 +431 2 14.1468 6.55272 6.36688 -10.1834 4.86047 2.66897 +432 2 12.7776 6.33144 5.63446 11.1073 4.86992 20.3892 +433 1 7.86929 2.3014 9.43186 -7.43999 -0.581733 -7.42672 +434 2 7.28758 2.26368 10.206 1.54253 -4.13193 1.23421 +435 2 7.37428 1.85692 8.71867 3.17855 7.90221 2.8646 +436 1 15.2039 14.7441 13.779 -1.62406 2.57688 -1.70285 +437 2 14.9354 14.9492 14.6806 -4.8726 3.09257 3.44485 +438 2 14.7582 15.3762 13.1995 0.661267 -3.02741 1.58802 +439 1 9.4149 8.38535 3.859 -25.1665 -10.991 -5.57318 +440 2 10.2049 8.88585 3.99067 20.2759 12.8236 2.22258 +441 2 9.67249 7.46496 3.96553 -1.56288 -2.67339 -2.00262 +442 1 17.7026 13.5834 16.4242 -1.80346 -11.0476 6.4727 +443 2 16.7549 13.3713 16.3986 -0.662501 7.25922 -2.44544 +444 2 17.8485 14.4294 15.9813 -4.13054 1.45271 -4.35383 +445 1 4.91191 10.5224 2.88074 35.1139 -21.7488 -13.7776 +446 2 5.74832 10.1175 3.20879 -18.1595 7.39309 -6.65206 +447 2 4.64711 11.0636 3.60968 -4.98951 12.9254 11.8317 +448 1 3.70989 8.40692 9.9178 -3.43098 -13.3807 16.77 +449 2 3.72102 9.34916 9.72654 3.49477 5.64054 -2.09668 +450 2 3.74613 8.34545 10.8924 -2.49133 1.09455 -12.0955 +451 1 15.9811 6.93645 5.90716 -9.64967 -5.56515 0.983492 +452 2 16.7246 7.40088 6.29715 7.31355 3.31596 3.21676 +453 2 16.2311 6.00551 5.84179 2.78737 3.87161 -3.53071 +454 1 15.2416 7.2288 8.97537 -25.1477 -13.3308 -14.4253 +455 2 15.9965 7.60799 9.37505 30.1105 10.4166 22.3283 +456 2 15.0439 7.80906 8.23828 -3.19363 1.15625 -6.55237 +457 1 6.20437 12.8345 12.7354 -14.1465 10.1654 -16.7884 +458 2 6.94522 12.3758 13.1101 18.4885 -10.5564 10.7987 +459 2 6.04629 13.6348 13.2503 2.66058 2.52169 8.79246 +460 1 12.1262 4.55048 13.1243 17.0811 13.049 12.1055 +461 2 12.3395 4.65477 14.0809 -9.37635 -6.07885 -14.152 +462 2 11.329 4.03313 13.0256 -8.31182 -5.5816 3.57791 +463 1 11.4354 8.07801 7.94226 -0.810806 3.70784 -8.7596 +464 2 12.2037 7.66847 7.47953 -11.1819 -0.00285319 12.9065 +465 2 11.6202 8.13058 8.89801 9.03316 -1.52538 -12.7532 +466 1 16.9943 10.8342 7.6109 -5.03955 -8.49642 17.9987 +467 2 17.7716 10.3123 7.42961 10.8043 -13.0503 -0.479497 +468 2 16.9113 11.4133 6.86596 -8.14606 13.8231 -19.3584 +469 1 5.21042 18.0585 10.7699 15.6232 7.92267 2.97831 +470 2 4.74775 17.5474 11.4283 -5.6196 -5.04348 5.46467 +471 2 4.57391 18.2408 10.077 -8.01525 -1.2934 -10.8517 +472 1 7.60043 17.4332 1.64042 6.79415 6.05281 -21.827 +473 2 7.93761 16.6332 1.20425 2.91062 0.230192 8.27204 +474 2 7.75711 18.1408 0.980897 -9.32049 -5.6032 10.0359 +475 1 1.93897 12.9382 13.63 3.13689 -3.11692 -16.6768 +476 2 1.43678 12.3217 14.1546 -10.1951 -7.38374 9.42459 +477 2 2.04891 13.7234 14.1672 6.66588 6.79896 5.37665 +478 1 9.3938 6.77683 14.8244 15.3217 -3.43003 -1.39025 +479 2 9.8639 6.00007 15.2423 -8.39432 15.0581 -15.9266 +480 2 9.75443 6.97816 13.9251 -4.83499 -14.7492 16.6004 +481 1 15.2802 4.37234 10.7612 17.1837 -0.598437 7.1821 +482 2 16.2442 4.23454 10.6079 -20.4209 -0.451849 5.19081 +483 2 15.2528 4.98337 11.5249 -0.66536 -5.42981 -12.7574 +484 1 11.4105 6.21551 0.0734026 -8.7314 7.93342 -2.27424 +485 2 11.3895 5.26963 0.0141504 12.2817 -18.3718 -0.889513 +486 2 10.499 6.41528 18.4856 -6.56297 9.87049 -0.998012 +487 1 18.513 11.4235 14.9225 12.9282 -22.681 3.72438 +488 2 17.9895 11.7369 14.1972 -5.90482 9.25399 -19.4183 +489 2 18.3571 12.0937 15.574 -0.537982 14.5307 17.0247 +490 1 7.08328 9.28085 7.30918 -19.7197 4.18214 5.56511 +491 2 6.73297 8.51044 7.78417 1.76821 -0.286333 -7.5509 +492 2 8.01676 9.1548 7.24802 24.3996 -5.081 -1.83944 +493 1 18.3255 15.3437 12.2137 -3.8694 0.735905 0.400418 +494 2 0.599616 15.5 11.9645 6.26195 2.32841 -0.363056 +495 2 17.7995 15.7522 11.5099 -2.40985 0.96637 0.371307 +496 1 16.511 4.37404 5.22763 -21.2214 -5.51878 25.3236 +497 2 16.4647 3.99489 6.12381 2.74309 1.28503 -9.80457 +498 2 17.4303 4.54035 5.0616 22.4703 -0.915278 -13.9933 +499 1 17.7218 3.13981 10.7749 -4.33552 13.9915 6.34554 +500 2 18.6231 3.34836 11.0663 1.21144 -2.68719 -3.11144 +501 2 17.734 2.28626 10.3485 2.99182 -14.4528 -5.38806 +502 1 12.2792 18.655 10.1327 17.2693 -45.8263 -15.1364 +503 2 11.5058 0.449575 10.4425 -26.2107 18.2097 8.79889 +504 2 13.0094 0.611642 10.1232 12.3896 24.8189 4.81349 +505 1 10.4214 9.73086 12.5154 -11.4047 -1.1898 4.78042 +506 2 11.1516 9.87418 13.1364 2.96428 -4.00819 -1.03044 +507 2 10.2474 8.77319 12.4992 9.30457 6.64045 -3.3636 +508 1 0.651598 2.68478 7.18172 -17.9134 21.5061 -11.8097 +509 2 0.347525 3.6016 7.34273 5.69642 -14.867 -2.54197 +510 2 0.849668 2.34638 8.05251 8.91351 -8.30419 8.52406 +511 1 0.318497 15.272 6.90444 -3.43175 -0.902574 -18.2314 +512 2 0.478582 15.5644 7.78858 6.40513 2.68345 23.4663 +513 2 0.623162 14.3599 6.89897 0.272636 -4.92753 -7.69196 +514 1 17.0533 6.94572 15.0273 7.81631 0.565766 -0.894277 +515 2 17.8128 7.55845 14.958 -6.36521 -5.11302 -0.197876 +516 2 17.4132 6.11744 15.3876 -1.58799 4.21551 0.905627 +517 1 9.15046 12.5368 8.00027 -36.358 14.0028 8.44058 +518 2 9.59383 11.9142 7.43445 3.21629 -19.4527 -15.2125 +519 2 8.22229 12.648 7.66907 25.8785 -7.47424 5.38289 +520 1 1.16102 1.67919 2.79298 -14.264 -19.5534 -4.4961 +521 2 1.06769 2.21394 1.99483 -1.93616 3.76767 1.09072 +522 2 1.84572 2.00753 3.35812 13.0572 19.5695 8.60311 +523 1 4.13351 15.1441 9.8761 6.18483 -5.86151 -6.61306 +524 2 3.91524 15.1965 8.93344 2.62784 3.42174 0.908977 +525 2 5.03514 14.7702 9.87632 -7.63961 1.62567 3.94135 +526 1 7.3909 2.2738 14.7748 9.28558 9.05007 -9.33433 +527 2 7.12441 1.5503 14.2057 -1.53405 -3.63662 -1.19206 +528 2 7.87829 2.88836 14.1809 -18.0097 -8.54319 17.0088 +529 1 18.3492 14.5565 2.15246 12.0934 24.362 7.12212 +530 2 0.551729 14.8667 2.53499 -6.69921 -6.84856 -6.85574 +531 2 17.7888 15.364 2.12839 1.3753 -15.6354 -3.85708 +532 1 10.0163 2.6808 12.9164 -0.493731 -5.11601 -9.40492 +533 2 9.92018 2.0572 12.1601 0.76191 10.4011 8.73608 +534 2 9.26265 3.29452 12.869 4.65507 -2.10266 -3.09911 +535 1 2.95427 8.9021 13.1034 24.5728 -3.04867 -5.91166 +536 2 3.51177 9.68096 12.817 -20.8286 -16.9148 9.19061 +537 2 3.59809 8.18481 13.2917 -7.73525 14.463 -2.49767 +538 1 3.26448 8.6069 3.78485 -10.2248 -21.121 34.5648 +539 2 3.76672 9.19042 3.24166 13.0731 20.305 -12.8555 +540 2 3.48359 8.83627 4.72374 -5.93153 -5.30867 -25.3462 +541 1 5.8473 7.24819 8.6208 2.3932 7.90906 9.86277 +542 2 5.81432 6.28497 8.53212 -5.5277 -2.57364 -0.635967 +543 2 5.0659 7.54439 9.12071 1.08185 -7.49096 -4.29671 +544 1 14.8764 1.57981 1.83846 12.2497 10.4795 -14.7641 +545 2 15.1104 2.2908 2.43504 -9.02026 1.90223 13.0204 +546 2 15.3525 1.8445 1.03212 -8.04537 -15.132 5.23431 +547 1 8.61698 15.0264 0.696156 7.89205 -2.64916 2.43147 +548 2 9.41092 14.8348 1.25307 -18.4618 8.30064 -5.38467 +549 2 7.89576 14.464 1.0316 3.03152 0.23278 2.41128 +550 1 15.4513 1.4301 7.20503 6.99627 -6.82188 0.69389 +551 2 14.8244 0.90582 6.69357 -2.8394 0.789398 0.0418873 +552 2 15.0149 2.26607 7.38205 -7.95005 6.31947 4.24803 +553 1 4.96675 12.927 18.445 -0.392058 -1.0762 11.0005 +554 2 5.34886 12.9244 0.695922 -4.30965 1.19363 -4.30526 +555 2 5.68 13.266 17.9034 2.74534 3.65082 -4.88489 +556 1 15.3953 8.66034 18.0902 -2.07624 -16.7815 -3.18775 +557 2 15.9144 9.19311 17.4724 -5.66293 4.97787 2.21077 +558 2 15.1583 9.22886 0.188985 2.48846 7.45062 3.31632 +559 1 12.0359 3.11648 18.28 -8.04977 7.84102 -5.19135 +560 2 12.2901 3.11968 0.565205 5.43673 -10.4163 -2.44039 +561 2 12.4787 2.41139 17.7764 2.20222 0.638625 8.9068 +562 1 13.1884 12.6911 5.14611 -2.25763 -6.31837 -0.123489 +563 2 13.4652 11.7849 4.90596 3.78769 10.9202 3.38983 +564 2 13.3386 12.7839 6.10454 1.74722 -2.69816 -5.37077 +565 1 6.12211 7.19464 0.152335 -0.889801 -16.5081 12.3486 +566 2 6.2475 8.12337 19.0248 -9.08967 1.02729 -5.81202 +567 2 5.35557 6.85974 0.666933 3.80599 9.00251 -10.0268 +568 1 17.6814 15.8746 14.896 -32.95 0.345881 -9.96463 +569 2 16.7135 15.9334 14.9982 15.4899 6.1636 11.5551 +570 2 17.7111 15.6936 13.9484 19.9419 -0.275145 -3.25111 +571 1 13.1284 0.88699 16.7751 -4.95458 6.20661 5.10718 +572 2 14.0638 0.660956 16.7688 7.30918 -0.228866 0.981928 +573 2 12.6898 18.6827 16.6682 -2.70263 -7.7996 -4.366 +574 1 10.8711 14.4993 7.46323 15.7126 -17.3597 -1.2585 +575 2 10.128 14.0173 7.85917 4.58757 6.56369 -3.56814 +576 2 11.6082 13.8461 7.48059 -10.4237 16.2655 0.791757 +577 1 17.6751 8.40087 2.13849 -13.7675 10.6042 3.42109 +578 2 16.7708 8.37025 2.51335 11.2555 0.423493 -3.0905 +579 2 17.6147 7.881 1.33167 1.95975 -7.58305 -2.5048 +580 1 12.424 7.82566 2.03348 6.80204 18.2298 -3.36389 +581 2 12.2928 8.74872 1.74157 -3.31877 -9.32949 5.70746 +582 2 11.9673 7.27395 1.39444 0.405274 -3.29714 -11.9602 +583 1 12.0088 14.6056 10.3972 49.4943 -15.6831 -19.0447 +584 2 12.4654 14.316 9.56616 -19.1829 7.51475 23.0356 +585 2 11.0956 14.6861 10.1978 -35.275 4.57666 -6.07844 +586 1 6.81054 6.90501 15.534 -24.6279 -1.31201 9.93627 +587 2 7.70831 7.14913 15.3109 11.0416 1.99651 0.427612 +588 2 6.48555 7.50951 16.2192 7.91049 -4.43387 -1.91407 +589 1 7.94039 4.47545 13.2332 14.4982 34.8647 21.806 +590 2 7.26408 4.6474 12.5684 -6.44209 3.92223 0.968251 +591 2 8.05746 5.34482 13.7439 -3.25809 -36.365 -21.9094 +592 1 13.3499 12.2014 14.3127 -1.24116 1.37617 13.1465 +593 2 13.3241 11.2332 14.3368 -6.04942 0.470969 -4.28371 +594 2 13.6308 12.4336 13.4212 3.90264 0.498209 -3.09495 +595 1 14.5954 9.45997 7.28998 13.2192 -1.86441 -1.0042 +596 2 15.4197 9.90762 7.5754 -11.2574 0.0534663 -4.99205 +597 2 13.8535 9.8793 7.72336 -3.17401 5.05716 8.17378 +598 1 12.6619 16.8656 3.26711 -0.0867316 -13.7478 -1.21165 +599 2 12.9036 17.3981 4.01825 1.80146 10.547 8.89773 +600 2 12.7645 17.4143 2.493 -0.0316456 12.4477 -7.66427 +601 1 1.00141 7.10091 17.3455 15.3286 -2.27437 -0.63111 +602 2 0.197357 6.73674 17.6796 -23.7065 -4.2556 16.6559 +603 2 0.696205 7.72166 16.6912 7.12828 11.4292 -16.7267 +604 1 12.984 4.84784 15.752 -30.1278 -7.6986 -1.85236 +605 2 13.773 4.32613 15.627 12.1969 -0.534485 4.03194 +606 2 13.2127 5.76882 15.785 16.3015 19.3583 1.60965 +607 1 2.35806 3.40155 5.13736 7.00458 -19.3644 -43.6846 +608 2 1.86996 2.9687 5.81855 -13.4119 -5.52905 24.958 +609 2 2.73401 4.18924 5.49805 8.9837 23.3098 13.0491 +610 1 8.19273 10.9521 13.6844 -8.81681 4.64201 23.2716 +611 2 8.19092 10.7627 14.6526 -0.424045 0.881441 -21.4162 +612 2 8.95149 10.4932 13.3231 15.2004 -1.23984 -4.72202 +613 1 13.0449 1.52469 13.2577 -17.2068 8.30684 11.3152 +614 2 13.5293 1.59874 12.4201 -3.55841 -0.219514 3.90721 +615 2 12.4208 2.28784 13.3343 18.9425 -17.4385 -9.09999 +616 1 6.61166 13.6023 2.12464 -9.14589 11.0627 -26.7302 +617 2 6.03511 14.0379 2.75872 -4.67031 1.02227 7.02539 +618 2 7.1693 13.0213 2.62577 8.97168 -8.12604 14.3361 +619 1 15.8326 6.37868 12.5447 13.0084 18.5244 20.7727 +620 2 16.3675 6.96965 11.9727 -5.6566 -10.5049 5.53461 +621 2 16.1589 6.56267 13.4684 -3.25982 -7.33208 -24.589 +622 1 16.7829 0.679169 9.53725 3.65315 -1.00951 10.2573 +623 2 16.653 18.4141 9.83094 1.34292 -7.75704 2.15353 +624 2 16.269 0.772043 8.73148 -3.87084 4.41009 -12.8197 +625 1 6.12871 11.643 8.2509 28.8456 37.0564 -10.7514 +626 2 5.32101 11.4251 8.67159 -25.2961 -16.2243 16.4685 +627 2 6.59615 10.8374 8.068 1.48557 -20.4229 -4.39625 +628 1 2.81588 8.6455 0.385911 -12.1168 -14.4708 -15.8933 +629 2 2.2408 8.27575 18.315 12.5525 5.70225 18.3425 +630 2 2.25296 9.2478 0.88122 -2.81952 5.7616 1.15354 +631 1 10.1112 10.3249 6.56463 -6.88185 10.2676 4.3595 +632 2 10.6724 9.72741 7.0699 2.3169 -7.24343 0.885556 +633 2 10.4905 10.3984 5.68005 1.7842 -2.70629 0.197339 +634 1 6.85117 15.7741 6.71172 -4.51814 -4.38518 8.0947 +635 2 7.10947 16.276 7.50071 -0.280141 -2.70051 -1.05147 +636 2 7.0022 16.3747 5.97143 2.95927 2.8361 -5.64101 +637 1 6.55245 12.8624 5.85582 3.66478 4.31955 2.99752 +638 2 6.71899 13.7301 6.24424 -0.933807 5.79026 -3.46681 +639 2 6.12481 12.3549 6.55179 0.263982 -0.200358 2.15574 +640 1 16.7435 12.5401 9.7846 -13.9618 -8.21713 16.7649 +641 2 16.8388 11.8663 9.10427 2.99064 0.578166 -4.74348 +642 2 17.1608 13.3339 9.48085 7.01955 11.3182 -8.14386 +643 1 6.27773 2.82725 2.7475 -16.1332 4.52919 -16.5002 +644 2 6.37029 3.76301 2.48637 6.52487 -6.75351 6.59876 +645 2 5.7241 2.45518 2.0296 8.37538 -0.331655 9.00677 +646 1 10.7419 2.97566 3.2545 -3.93098 2.36946 -8.35386 +647 2 10.3631 3.83794 3.45313 -5.44824 -1.84651 0.91029 +648 2 10.2755 2.65841 2.45654 4.06882 -1.04864 5.83378 +ITEM: TIMESTEP +90 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.80968 6.6261 17.8375 -14.5778 0.995444 8.41947 +2 2 7.95772 6.60642 18.3334 15.3437 1.8775 -14.2431 +3 2 8.74654 5.99095 17.1112 1.57504 -1.57025 6.7209 +4 1 0.142832 8.36014 6.73441 10.0116 -15.4349 27.0014 +5 2 0.232649 8.20449 5.79462 4.11725 -7.32768 -11.6468 +6 2 0.67494 7.65251 7.20998 -18.6261 25.5606 -16.1468 +7 1 8.65703 0.380136 6.98192 16.3005 -1.0776 2.50655 +8 2 9.57515 0.309779 6.66722 -10.0942 0.994659 4.05519 +9 2 8.27212 1.03395 6.395 -6.58679 0.322126 -3.42087 +10 1 6.47941 1.69165 11.7468 2.00503 -21.4393 -6.03474 +11 2 5.9725 2.29393 12.2744 -13.1143 10.2157 7.12378 +12 2 5.89376 0.920881 11.5936 7.71629 6.15291 -2.33076 +13 1 6.9103 5.50063 2.38437 -35.7814 23.4203 2.69428 +14 2 6.20944 5.92743 2.96221 29.3961 -15.7919 -7.47581 +15 2 6.73166 5.94071 1.53167 10.6635 -7.16691 8.95661 +16 1 16.211 10.2361 16.1124 -22.7966 -2.93172 13.0323 +17 2 16.937 10.2632 15.5246 28.6916 5.0146 -15.8412 +18 2 15.9737 11.152 16.3021 -3.36115 -0.429235 -4.16748 +19 1 10.8196 14.9788 2.33309 -6.31813 -9.42536 4.48609 +20 2 10.7437 14.525 3.19227 -2.25161 -0.175376 -6.3843 +21 2 11.168 15.8375 2.56675 6.6431 8.63317 3.56201 +22 1 17.1655 8.21466 10.9616 20.3007 -11.9207 -19.649 +23 2 16.6876 8.89778 11.4174 -14.8371 14.2918 8.905 +24 2 17.9353 8.67496 10.5709 -5.82559 -3.7293 4.59063 +25 1 14.5981 15.9748 16.3536 13.4587 -18.0704 19.8012 +26 2 13.6875 16.2688 16.3636 -10.2246 8.72504 -7.33216 +27 2 14.6733 15.4751 17.2031 2.63957 5.2712 -15.5493 +28 1 12.1292 13.2811 0.580093 14.6523 -12.0599 13.1814 +29 2 11.875 13.3883 18.3092 -10.372 6.98394 -12.7652 +30 2 11.639 13.8901 1.1449 -2.74566 6.59249 -3.74219 +31 1 9.34925 5.48981 3.82539 12.3818 -0.191077 28.8485 +32 2 8.80634 5.44704 4.61652 7.17551 -1.92534 15.5524 +33 2 8.65833 5.42982 3.20736 -26.4153 -0.989629 -43.3837 +34 1 1.57757 3.9189 11.5719 -21.368 33.8782 -18.8992 +35 2 1.50486 4.82423 11.9434 2.77 -7.29772 -4.79385 +36 2 1.95891 3.38097 12.2317 20.2106 -22.0339 29.781 +37 1 2.11583 6.92705 8.12278 -10.2704 -2.23476 -15.4196 +38 2 2.47676 7.42607 8.85663 6.65774 -1.70501 8.2798 +39 2 2.06913 5.99576 8.38149 2.03129 -2.32531 8.57063 +40 1 5.2846 4.43559 7.83749 -11.1092 26.0267 -7.92074 +41 2 5.42959 3.50305 7.74019 3.58921 -20.4287 3.63869 +42 2 4.59753 4.67739 7.1831 9.16507 -0.464339 6.41033 +43 1 3.36483 2.87842 17.4354 -5.48754 -0.0293267 11.8999 +44 2 4.0122 3.13798 16.7945 16.5223 13.9802 -16.1706 +45 2 2.91387 3.69111 17.7275 -1.08839 -5.27878 2.29607 +46 1 7.51128 5.54904 6.16479 9.71808 2.6671 3.00483 +47 2 8.12131 6.08033 6.71556 -9.69992 -1.44216 -4.10694 +48 2 7.04033 4.98631 6.78947 -1.48399 -2.17988 -0.0590646 +49 1 9.79239 7.0023 12.0333 -12.7203 -1.67256 -9.54047 +50 2 10.0574 6.1295 11.7028 -2.54946 7.94968 0.438659 +51 2 9.0334 7.28866 11.4661 15.1177 -5.87574 8.09476 +52 1 14.1269 3.84395 8.13857 -24.8841 12.3935 -19.8999 +53 2 13.4363 4.47719 7.80064 24.2741 -16.3277 6.83338 +54 2 14.3749 4.15432 9.00462 4.04893 6.4318 14.0535 +55 1 4.52686 17.2232 3.85531 -7.09571 -9.71268 16.0786 +56 2 5.35353 17.6803 4.02689 3.89364 6.28665 -2.88462 +57 2 3.96567 17.7155 3.24673 4.45666 4.6431 -9.26961 +58 1 16.1958 16.5107 10.5377 18.4287 -13.9772 -31.1199 +59 2 15.4454 16.6557 11.0933 -16.6117 1.05393 13.9092 +60 2 15.8645 15.9242 9.81336 4.55855 15.7974 16.2758 +61 1 1.967 4.85121 0.0645769 9.40837 -19.0171 0.778776 +62 2 2.73793 5.10942 0.56616 3.15966 4.76786 17.0447 +63 2 1.80075 5.61055 18.1709 -12.801 18.3624 -15.2179 +64 1 11.1737 13.314 16.4367 2.74473 1.78814 5.72217 +65 2 10.7128 12.4641 16.5748 8.32361 2.87799 -7.58216 +66 2 11.8417 13.1969 15.7431 -5.18043 -7.14508 -0.417807 +67 1 10.0458 10.8999 16.8205 33.4394 -5.51473 9.19041 +68 2 10.5428 10.0531 16.9406 -15.1708 22.1127 -3.77119 +69 2 9.12902 10.6892 16.7607 -22.7906 -6.8787 -3.44008 +70 1 11.889 17.5084 13.4814 3.48745 6.24304 -13.0003 +71 2 12.5913 17.1622 12.8998 -9.91022 -4.16273 6.93206 +72 2 12.0139 18.4633 13.4204 2.43964 2.21886 2.73389 +73 1 6.44228 9.49569 12.2996 9.71147 -12.8692 -34.1322 +74 2 7.06965 9.17025 11.5988 -17.7592 6.4035 17.1392 +75 2 6.97144 10.0526 12.8659 4.91959 6.23922 4.73193 +76 1 16.3022 12.832 2.75135 -12.5209 9.65366 -4.24277 +77 2 17.1598 13.1655 2.44684 -4.70434 0.462679 5.46936 +78 2 15.6996 13.6248 2.74248 12.9928 -20.5688 3.1232 +79 1 0.706696 12.7395 5.83755 -10.6776 2.47735 15.1944 +80 2 1.02688 12.9731 4.95908 -4.07327 -10.4263 -9.29508 +81 2 18.3891 12.5308 5.80039 14.5368 6.4085 -10.1514 +82 1 5.29875 16.3254 18.4501 12.7507 -5.44046 -6.67673 +83 2 5.72604 15.6129 17.9385 -8.69196 7.59677 5.8406 +84 2 6.01274 16.6418 0.375909 -8.3334 1.51688 4.30584 +85 1 0.743878 7.68205 4.10167 -26.7478 -30.2572 33.4946 +86 2 0.179417 7.92019 3.37827 -7.5716 9.21403 -16.4097 +87 2 1.60385 7.98113 3.89879 36.269 17.899 -12.2731 +88 1 3.22103 9.09598 6.53924 -28.7289 15.6764 -27.4701 +89 2 3.63534 8.61301 7.2251 9.03881 -15.9481 23.3571 +90 2 2.25678 8.88215 6.53178 21.3431 5.76786 5.41461 +91 1 7.2773 10.3926 16.241 -1.60955 -9.9776 11.4431 +92 2 6.63502 11.108 16.2935 -0.090439 -0.440245 3.15105 +93 2 7.09074 9.80627 16.9963 -3.87073 10.8392 -3.46734 +94 1 11.0095 0.891279 5.03438 2.23591 -17.8064 16.3849 +95 2 10.8775 1.7336 4.57918 5.69275 -3.07397 -7.72854 +96 2 10.7003 0.188666 4.43596 -0.931337 13.9517 -3.17827 +97 1 4.21583 2.94335 13.1635 9.62289 2.41259 16.4284 +98 2 4.47922 3.3428 14.0131 -5.18172 -0.255184 -10.0037 +99 2 4.1364 2.00091 13.3783 -2.2119 -1.88246 -4.82143 +100 1 8.45625 10.2801 1.81127 9.01648 -22.0588 9.24648 +101 2 8.30671 10.8697 2.54783 -2.77767 16.2884 7.52121 +102 2 8.66335 9.4444 2.27657 -0.852681 8.00384 -10.6723 +103 1 10.2261 1.659 15.4538 -6.06042 8.31352 -11.6288 +104 2 11.1361 1.48308 15.6359 20.1952 -3.56794 7.64131 +105 2 10.2187 1.98601 14.5369 -5.79366 -2.30068 5.3707 +106 1 2.60435 12.742 7.94637 -6.15341 0.568057 0.983218 +107 2 3.03975 13.5699 7.72118 6.64853 3.0435 -2.79803 +108 2 1.95513 12.6117 7.24141 1.86204 -3.09485 1.26562 +109 1 3.88579 11.7956 5.01149 -19.6155 -13.0634 1.96641 +110 2 3.74363 11.1082 5.69355 0.727972 11.568 -8.07528 +111 2 3.05901 11.8342 4.47209 17.5209 1.69759 11.0979 +112 1 6.76239 14.55 16.9383 -0.403452 -2.75277 4.08609 +113 2 7.61561 14.9826 17.0312 2.52456 -1.29817 -0.221044 +114 2 6.44911 14.7692 16.0549 2.09428 -3.60588 -3.74869 +115 1 14.1942 14.5231 3.16652 -5.12336 -14.4242 4.12891 +116 2 13.6899 15.3256 3.31261 0.149267 9.23779 -5.23449 +117 2 13.7696 13.8761 3.7521 4.09464 2.97302 0.255936 +118 1 8.7401 18.0877 16.1157 -15.0544 -15.1521 5.72203 +119 2 9.42706 17.4939 16.3945 -6.08837 -23.732 7.70311 +120 2 9.27218 0.11536 15.7481 8.35971 40.209 -14.9349 +121 1 4.63391 1.71898 4.89 36.0507 -5.82478 -13.0459 +122 2 3.81997 2.19927 4.85319 -16.3674 13.8452 0.00946397 +123 2 5.20292 2.04685 4.14723 -16.8402 -3.94878 19.5369 +124 1 15.0105 12.65 16.5031 22.0082 2.89039 39.0948 +125 2 14.6032 12.5883 17.4132 0.919275 4.87615 -33.2046 +126 2 14.3966 12.5461 15.7793 -22.8851 -3.84554 -8.75239 +127 1 15.7197 18.424 16.8504 13.0838 27.0964 8.25258 +128 2 16.3964 18.519 17.5419 -1.36847 2.51381 -4.544 +129 2 15.6686 17.4972 16.714 -13.5977 -31.6712 -2.03374 +130 1 1.39308 1.32386 16.6798 -9.07755 4.26299 3.83254 +131 2 2.19455 1.8573 16.8358 -13.1892 -10.0845 0.867767 +132 2 0.760663 1.62622 17.366 11.6728 -4.82483 -8.86289 +133 1 18.2416 4.3099 15.966 -4.36834 -5.16176 -14.6355 +134 2 17.7783 3.61219 15.465 8.57404 10.6893 6.25867 +135 2 0.425079 4.50442 15.5034 -5.04787 -4.14191 4.79432 +136 1 12.0688 17.0582 16.1192 -6.60497 -5.44285 54.7429 +137 2 11.374 16.6436 16.7154 18.2098 8.22439 -32.524 +138 2 11.7541 17.1189 15.223 -7.97888 -4.44492 -17.7493 +139 1 16.0987 2.72798 18.2222 -6.94033 2.52412 -3.34156 +140 2 15.6657 3.49187 18.6187 5.88163 2.98889 4.51464 +141 2 15.8079 2.8031 17.3159 -2.77048 -8.0731 -14.4365 +142 1 6.58612 13.762 10.0351 1.63352 -0.32404 13.73 +143 2 6.39624 13.3299 10.8846 2.34483 4.77487 -0.634471 +144 2 6.55421 13.0562 9.39028 1.369 -6.64332 -8.7831 +145 1 10.1169 18.5721 2.70869 27.9004 -1.02691 -4.20355 +146 2 10.7561 0.140951 1.98734 -15.1054 -0.137902 13.7961 +147 2 9.28626 18.3596 2.30468 -14.2521 -4.05351 -7.65243 +148 1 3.07988 17.6804 6.1902 -35.1734 2.13391 -17.3705 +149 2 2.15682 17.7525 5.8242 24.0448 -4.32039 20.662 +150 2 3.55195 17.7661 5.36197 20.4585 -2.58277 -0.69289 +151 1 12.6061 16.7775 7.89366 1.16584 -8.73771 -17.6522 +152 2 11.856 16.1922 7.7211 -0.763759 -4.24653 -1.89641 +153 2 12.3057 17.3353 8.59898 -2.13454 17.8975 18.5826 +154 1 14.8965 15.3132 8.35277 -22.4274 15.9599 0.214205 +155 2 14.2421 15.9941 8.02515 16.4945 -20.4059 13.6979 +156 2 15.4898 15.1572 7.61828 5.37632 7.31151 -11.1374 +157 1 17.8957 18.2766 0.201476 9.69326 -17.5267 -0.973127 +158 2 18.6995 17.7195 18.781 -12.0492 3.04369 -7.3597 +159 2 18.2321 0.401263 0.645934 -1.5685 17.2308 6.22008 +160 1 0.802158 10.4818 1.45184 -19.0828 -29.4994 30.4216 +161 2 -0.0309651 10.0246 1.77565 29.2477 9.1244 -14.7118 +162 2 0.53478 11.1455 0.834437 -7.87366 18.9841 -18.3051 +163 1 1.85308 12.2863 3.27351 -7.97315 5.10175 -10.2215 +164 2 1.42551 11.5849 2.74616 7.16023 4.54594 2.45335 +165 2 2.09673 12.9814 2.63054 -3.38314 -5.43944 9.55244 +166 1 0.718881 17.2977 4.9616 -19.2906 6.0419 1.76293 +167 2 -0.10575 17.7685 5.12875 8.39755 13.2462 -10.2288 +168 2 0.622971 16.5645 5.55208 6.7728 -21.2776 10.1703 +169 1 1.03867 0.919889 9.35844 3.74022 -6.32288 33.4729 +170 2 1.10918 0.592533 10.3007 6.31379 11.0803 -22.721 +171 2 0.269914 0.464458 9.03134 -8.6906 -2.38217 -7.04515 +172 1 16.7862 2.42581 13.3986 14.7457 27.0937 -15.311 +173 2 16.9847 2.74906 12.4891 -5.29709 -2.40963 18.2684 +174 2 16.5429 1.52129 13.2791 -8.06021 -27.7395 3.47759 +175 1 2.69738 16.0066 12.0777 13.1506 -14.7233 12.6976 +176 2 3.02715 15.5922 12.9029 -9.51867 9.47826 -13.4594 +177 2 3.28974 15.6737 11.3809 -2.31502 2.53439 -1.78657 +178 1 16.3754 15.4917 6.11201 -7.25585 -20.1131 3.67265 +179 2 17.3156 15.5044 6.29369 9.86882 2.22778 5.36532 +180 2 16.2073 16.2228 5.51797 -0.959992 10.1027 -9.31738 +181 1 5.7174 5.24337 11.7813 4.42707 -14.1004 -1.48072 +182 2 5.44277 5.99707 12.328 1.64183 -4.11158 -2.88134 +183 2 5.22325 4.47043 12.1002 -4.92771 7.03451 -4.06757 +184 1 15.1242 4.92712 0.766674 18.5408 -12.9138 10.3204 +185 2 14.9855 4.62556 1.67944 -3.08744 4.9541 4.0864 +186 2 14.3291 5.35182 0.492873 -21.4444 10.4963 -5.72763 +187 1 16.3798 16.4926 1.83048 25.9496 20.3657 -34.7081 +188 2 16.3432 16.8093 2.72897 -9.33108 7.61853 14.7037 +189 2 16.7914 17.2408 1.28765 -16.0156 -28.1785 20.3541 +190 1 0.157471 4.87182 3.99278 -9.81132 22.7056 -3.03191 +191 2 0.5332 5.76253 4.03054 -8.2904 5.08609 0.673103 +192 2 0.911036 4.31937 4.01308 22.6258 -22.4944 4.73784 +193 1 2.97603 15.0857 15.1688 -3.76699 16.0764 -9.28303 +194 2 2.87698 14.8354 16.0845 -1.20729 -14.2266 12.1787 +195 2 2.48786 15.9266 15.1702 1.40562 1.39337 -6.33902 +196 1 1.10637 14.6846 9.51596 31.8836 22.2572 14.4694 +197 2 2.01065 14.9183 9.89233 -34.4229 -12.9306 -18.6629 +198 2 1.03031 13.7317 9.56194 1.94445 -7.79278 4.16037 +199 1 13.55 16.5172 11.5597 10.1041 14.0808 -3.72584 +200 2 13.3442 17.2549 10.9555 -5.19335 -6.01443 7.16005 +201 2 13.1025 15.7566 11.183 -9.96101 -8.306 -1.961 +202 1 4.75563 1.55237 0.702796 10.3802 -26.0161 11.0265 +203 2 4.32304 2.05314 0.014379 -14.7339 5.42124 -2.63334 +204 2 4.14265 0.839056 1.00315 4.15161 14.819 -1.07901 +205 1 1.52656 18.6416 11.9009 -8.95117 16.8483 13.4998 +206 2 1.43825 0.48402 12.7573 3.56637 -8.71242 -18.201 +207 2 1.98334 17.8196 12.0914 3.68072 -6.34965 2.55122 +208 1 11.4393 10.1383 4.17836 -13.7636 4.05009 -8.78245 +209 2 11.3903 10.5027 3.28707 -1.50281 2.58284 -2.63304 +210 2 12.3655 9.96172 4.28712 17.4192 -2.53267 8.67839 +211 1 8.18359 12.1636 3.86104 -21.222 -14.272 -14.5003 +212 2 9.05859 12.5239 4.0446 -0.40723 6.23371 14.3883 +213 2 7.56046 12.2135 4.62832 23.1203 4.46306 -6.77507 +214 1 14.593 4.04535 3.38111 7.28555 -5.40785 -19.1504 +215 2 15.2127 4.15408 4.10794 5.52844 2.67895 3.03112 +216 2 13.7536 4.35259 3.70606 -13.9578 6.65801 6.31365 +217 1 5.72323 1.65443 7.61073 34.4 15.7962 37.2038 +218 2 5.13785 1.03104 8.01585 -19.7408 -11.9782 7.15973 +219 2 5.42676 1.78462 6.74294 -17.7695 -4.7826 -52.6001 +220 1 17.8873 1.06414 4.83181 6.8154 -0.232455 -4.71432 +221 2 18.4369 1.21178 4.04718 -2.79964 -1.76243 2.38037 +222 2 18.3376 1.55744 5.53048 -5.83965 -0.882229 4.9581 +223 1 6.85055 9.23648 4.54341 6.32277 -8.10519 -4.82585 +224 2 6.75809 9.38079 5.49182 3.88959 4.29486 1.07151 +225 2 7.79379 9.02149 4.39148 -10.7358 1.98669 4.12637 +226 1 2.55801 14.782 2.06648 -8.35029 -12.2797 -25.7867 +227 2 3.24533 14.7191 2.71695 15.3489 0.778658 13.055 +228 2 2.98421 14.5338 1.22242 -9.03529 10.4097 12.3511 +229 1 17.2667 12.9721 13.1114 -20.9369 36.2303 -2.57416 +230 2 16.4188 13.4451 13.3365 18.5804 -22.1292 -0.415694 +231 2 17.7749 13.7311 12.7641 -0.529191 -13.9074 0.965338 +232 1 14.8416 10.5583 1.56689 -2.78575 22.6182 14.2458 +233 2 15.4799 11.2066 1.96334 -16.8252 -10.4846 -9.71145 +234 2 13.9405 10.9259 1.71943 20.5685 -8.6057 -5.43477 +235 1 5.6352 6.7176 4.51351 -9.14706 -11.8638 3.15016 +236 2 6.0003 7.60062 4.53525 2.53301 15.852 -6.04122 +237 2 6.16933 6.24394 5.16122 6.25334 -1.18144 -1.3834 +238 1 8.0084 8.26626 10.2701 -4.49752 14.9075 -15.7864 +239 2 8.53054 8.9292 9.77232 -0.437986 -11.1673 11.0277 +240 2 7.35426 7.95022 9.61336 5.97292 -3.64509 13.4454 +241 1 13.4616 18.4657 5.71166 17.1322 -6.35165 -5.45305 +242 2 12.613 0.202175 5.51075 -18.0122 19.0124 -5.00284 +243 2 13.2587 17.813 6.37409 -3.85709 -10.1746 14.3256 +244 1 0.0252945 2.56986 0.408061 0.439602 -5.22175 -5.84652 +245 2 17.7844 2.56336 0.0359587 -11.4993 -5.28871 3.98864 +246 2 0.277142 3.47535 0.26454 16.627 13.7372 -0.461998 +247 1 12.8639 10.8267 9.72576 -55.6075 31.3565 -11.278 +248 2 11.8723 10.9451 9.72713 30.8534 7.0313 -2.47663 +249 2 12.8724 9.89108 9.83244 20.4971 -22.7651 5.79467 +250 1 0.607625 12.2828 11.1117 24.514 -2.72666 -9.78403 +251 2 18.2964 12.3126 11.1603 -11.5713 5.22338 7.13378 +252 2 1.01642 12.6716 11.9034 -8.98148 -2.79725 -0.830812 +253 1 5.29539 7.3549 13.3064 -7.85772 10.5518 3.63543 +254 2 5.70599 8.16396 12.9287 -0.549664 -12.4206 10.9242 +255 2 5.67568 7.22584 14.1948 2.69835 3.31529 -9.72444 +256 1 1.17555 6.77844 11.9244 -33.9372 -12.3631 -14.3141 +257 2 0.259637 6.99751 11.6106 25.929 -3.06653 9.08527 +258 2 1.58097 7.60434 12.1643 7.59492 14.5493 8.35248 +259 1 15.5141 9.76806 12.4302 -1.8656 17.4266 8.04916 +260 2 15.0855 10.6363 12.2204 12.2826 -22.7347 2.36453 +261 2 16.0019 9.91808 13.2494 -6.58523 -0.731675 -3.13373 +262 1 16.4968 12.5534 5.50851 9.37615 -29.7593 -4.66799 +263 2 16.3074 13.4744 5.68685 -5.44524 15.7433 -9.11055 +264 2 16.3732 12.3531 4.54775 0.322938 17.9758 14.7603 +265 1 6.32376 9.8903 0.169934 -28.7401 -0.365509 -5.18995 +266 2 5.50824 10.2805 0.557378 14.6251 -5.00462 -6.15541 +267 2 7.04833 10.2225 0.694867 12.727 0.898893 11.9262 +268 1 12.1515 6.04661 4.01259 -24.0177 -36.8905 11.864 +269 2 12.231 6.67099 3.30768 1.42994 18.9462 -13.2923 +270 2 11.2548 5.64061 3.89367 21.868 15.3866 4.7403 +271 1 0.316109 12.8908 0.0158726 1.97018 -1.90411 4.82087 +272 2 18.784 13.4984 0.752127 -2.36898 -0.989285 -3.79 +273 2 18.4247 13.2164 17.9164 2.23727 -3.47257 5.47524 +274 1 3.55093 0.0615484 8.6771 30.4928 -5.90286 -4.02028 +275 2 3.49841 18.2151 7.84215 -7.8476 4.22576 -1.41638 +276 2 2.7473 0.557235 8.76228 -21.0031 4.54937 0.225707 +277 1 7.3901 17.5352 4.48573 6.23592 32.7201 -14.6481 +278 2 7.69571 18.4853 4.57976 -11.8279 -33.7706 3.32686 +279 2 7.33788 17.4402 3.51852 2.74261 -6.71083 9.2357 +280 1 9.25 17.16 12.2333 -3.7288 14.5824 3.61249 +281 2 9.26512 16.5009 11.5521 -3.80961 -18.6559 -12.0666 +282 2 10.1634 17.2094 12.5273 3.6148 1.53928 10.2644 +283 1 13.402 13.1082 7.90091 0.220655 -14.9059 29.302 +284 2 13.4302 12.436 8.64233 -5.21958 14.4877 -25.9571 +285 2 13.929 13.8525 8.23076 3.39805 -3.2421 -4.10773 +286 1 14.8025 2.90677 15.4495 23.2091 4.40575 2.70159 +287 2 14.1483 2.29946 15.1328 -14.8482 -16.0174 -4.02081 +288 2 15.4935 2.87296 14.7763 0.208871 3.12507 -3.30872 +289 1 9.90762 15.6519 16.9195 -4.56731 4.54647 -2.1455 +290 2 10.1638 14.7845 16.5964 9.48907 -4.21512 -5.5698 +291 2 9.51082 15.4442 17.7618 -6.39245 0.962418 13.4848 +292 1 11.1953 8.50068 16.6178 -6.68582 -9.72424 -8.69684 +293 2 10.4052 8.01271 16.3331 5.65618 1.52157 -2.37675 +294 2 11.7201 7.85843 17.0918 5.14472 -5.56789 7.7477 +295 1 3.97964 18.2216 16.8609 -11.5365 11.132 -5.80894 +296 2 4.44261 17.5481 17.3724 7.79342 1.98205 9.06349 +297 2 4.16759 0.471834 17.2017 1.31413 -17.4358 -0.663005 +298 1 2.27286 4.25928 8.9046 8.30035 -0.830932 12.3077 +299 2 3.22373 4.0264 8.87035 -15.4899 4.40379 3.11293 +300 2 1.97207 4.14495 9.83591 10.7423 -1.42059 -17.2737 +301 1 9.92348 10.3926 9.8203 -1.21029 -1.85278 -24.2235 +302 2 9.36782 11.1029 9.49607 0.630055 7.16446 -2.16893 +303 2 9.82869 10.3844 10.7566 4.49005 -1.30636 29.4196 +304 1 9.77911 0.915187 10.8241 -1.58049 4.53496 -1.50662 +305 2 9.30516 0.126632 11.1017 -0.152878 -7.87834 6.94802 +306 2 9.15539 1.38664 10.2518 4.51752 0.176684 -4.82426 +307 1 9.1489 15.1729 10.179 6.96198 -6.50551 5.53221 +308 2 8.91001 15.8322 9.53904 -4.06695 15.478 -9.20984 +309 2 8.38415 14.5913 10.1616 -4.75674 -5.76082 4.02117 +310 1 0.743465 9.68917 10.1631 30.9903 9.57445 -5.37239 +311 2 0.884314 10.6156 10.4664 -8.35327 -15.1374 -2.2352 +312 2 1.62506 9.41264 9.82336 -24.2866 3.90606 7.18729 +313 1 17.1113 4.7779 8.02102 2.26389 -23.2748 8.45538 +314 2 16.3418 5.309 8.21811 -5.84575 9.78705 2.38191 +315 2 17.0463 3.99595 8.60382 3.74785 14.695 -9.14029 +316 1 14.847 14.6269 0.171171 -19.7527 -14.4968 -14.2937 +317 2 15.5321 14.9161 0.755334 10.0132 13.2257 15.972 +318 2 14.1228 14.2968 0.729437 5.50655 3.69994 -2.14986 +319 1 3.90456 11.0507 9.5998 -4.69832 -0.998696 -0.0493525 +320 2 3.86255 11.1688 10.552 1.28841 5.10968 9.84865 +321 2 3.27063 11.6917 9.24194 0.0177884 -1.71993 -8.82733 +322 1 11.433 10.7439 1.41897 29.5023 2.97313 10.7876 +323 2 11.6019 11.6536 1.12948 3.85703 -2.03295 -2.25776 +324 2 10.504 10.6413 1.35913 -35.0433 -4.68689 -6.35229 +325 1 13.1835 7.21214 12.6412 -8.23521 -20.1104 -3.47812 +326 2 14.127 7.05932 12.5127 3.33109 -0.638199 4.03042 +327 2 12.8061 6.29857 12.6985 3.22225 19.9882 2.50286 +328 1 9.65928 1.95745 0.843925 10.2182 6.36996 -3.06277 +329 2 8.81763 1.63483 0.51897 -5.65357 2.11518 2.03686 +330 2 10.1334 2.26536 0.0610097 2.29468 0.231167 4.03759 +331 1 10.5974 13.4461 4.57973 -2.39764 -3.17335 8.92217 +332 2 11.4415 12.9723 4.66721 0.170993 3.79528 3.71784 +333 2 10.3828 13.7711 5.47244 5.6647 1.39651 -7.04866 +334 1 14.5805 1.64306 10.9903 3.01891 29.9103 -7.34195 +335 2 15.4206 1.31489 10.661 2.43812 -13.4824 -3.17866 +336 2 14.6923 2.61327 10.8523 -8.77415 -13.7688 6.87151 +337 1 14.4577 12.0498 11.5485 -29.7481 -1.24334 12.4997 +338 2 15.1787 12.3182 10.9897 13.6492 5.38623 -14.4259 +339 2 13.7324 11.7114 10.9784 17.3586 4.51945 3.50834 +340 1 8.16823 5.15587 9.894 -28.9634 21.8059 19.126 +341 2 7.25961 5.26999 10.2972 28.5921 -4.04796 -11.5402 +342 2 8.23961 4.23455 9.67377 -1.01689 -19.4985 -4.69706 +343 1 1.66839 17.0027 18.4477 20.9596 26.331 -27.2012 +344 2 2.19503 17.5247 17.7665 -16.8758 -18.2972 22.1195 +345 2 1.83767 16.0826 18.2308 2.67698 -10.8321 1.22526 +346 1 1.40907 17.4029 15.3161 -1.8056 14.8407 8.29727 +347 2 1.4134 18.2156 15.8633 3.96238 -8.68525 -7.97287 +348 2 0.471831 17.1989 15.2085 1.34275 -7.61847 -1.46046 +349 1 3.49459 5.75594 6.06077 -10.0958 -15.2551 6.44531 +350 2 3.00844 6.4276 6.56158 3.56089 -0.0685925 -1.76679 +351 2 4.03572 6.19023 5.40706 10.0519 13.1926 -8.23224 +352 1 12.6765 9.5142 14.2706 -5.75697 27.7722 -14.2581 +353 2 13.0673 8.79775 13.7668 1.15853 -14.5514 3.26719 +354 2 12.382 9.20431 15.1249 -1.95515 -14.6959 8.85488 +355 1 4.11243 15.2112 7.12768 13.4261 4.57048 -4.21166 +356 2 3.68336 15.9917 6.77855 -13.243 7.84695 -2.74865 +357 2 5.05149 15.4218 6.9541 -4.34911 -9.58911 5.5273 +358 1 0.807347 8.85082 15.1137 12.1653 -16.291 -5.21716 +359 2 0.579225 9.7725 15.0704 -11.1033 15.5539 4.56692 +360 2 1.61112 8.83255 14.5724 -2.7466 -7.45742 -2.63208 +361 1 12.955 8.28126 10.1315 4.47425 -26.4789 2.77461 +362 2 13.6724 7.69661 9.75218 -12.3213 15.4477 18.6624 +363 2 12.7996 8.04439 11.0766 12.5165 -4.13221 -14.8671 +364 1 15.2413 7.99312 3.46307 21.2061 37.6089 -22.4299 +365 2 14.4756 7.7211 2.94477 -5.95544 -17.8301 8.14742 +366 2 15.6187 7.46858 4.17258 -15.9179 -18.0198 8.83427 +367 1 17.1356 6.70525 18.6386 6.47512 25.7091 -12.2215 +368 2 16.6963 5.89525 0.233999 -10.309 -8.75159 3.76643 +369 2 16.4339 7.33237 18.3357 11.2115 -13.3479 10.1501 +370 1 8.91981 7.02641 7.93476 -17.5815 -13.9195 9.00305 +371 2 9.83812 7.25537 7.853 19.0031 7.73693 -0.560136 +372 2 8.849 6.45385 8.72921 -1.20537 6.38433 -11.1549 +373 1 12.4784 0.471427 1.2 -1.5382 -11.3036 2.52426 +374 2 13.1724 0.955828 1.65737 6.96212 2.95671 -0.139484 +375 2 12.8855 0.124586 0.40059 -1.81614 4.12295 -0.743523 +376 1 5.7338 15.0104 14.483 3.21537 -3.99883 -6.81615 +377 2 4.79914 15.0689 14.6899 -13.3072 1.49299 3.3932 +378 2 6.00174 15.8892 14.196 3.10174 7.95604 -0.192962 +379 1 3.73322 6.46389 1.74186 4.97145 -11.2752 -15.478 +380 2 3.41061 7.27444 1.33141 -3.85483 5.16021 2.72417 +381 2 3.71896 6.61791 2.68352 1.01313 6.07651 8.98471 +382 1 3.85612 11.3357 12.3214 9.74989 2.64833 3.1782 +383 2 4.70398 11.747 12.5616 1.03181 -4.89631 -4.08494 +384 2 3.21292 11.8498 12.8111 -10.0411 9.11388 1.93155 +385 1 5.31882 3.86098 15.7247 -14.6622 43.9235 8.42988 +386 2 6.03513 3.29574 15.4808 24.4173 -17.8012 -3.50674 +387 2 5.69837 4.77513 15.8552 -8.87612 -28.0013 -6.19005 +388 1 14.0506 10.0984 4.70507 12.9021 5.9963 -48.2497 +389 2 14.373 9.82203 5.54065 6.42583 -15.3441 32.1568 +390 2 14.6577 9.66966 4.04903 -16.6446 6.96016 16.1133 +391 1 7.63016 17.2999 9.07082 4.88589 -1.83029 4.08955 +392 2 7.05774 17.6443 9.76408 -9.77236 -5.61109 0.722829 +393 2 7.90646 18.0745 8.58282 6.82018 7.73796 -12.3688 +394 1 4.54853 14.4989 3.92298 4.51049 -12.0827 -19.4455 +395 2 4.48676 15.3439 4.34231 1.7531 23.2793 6.06498 +396 2 4.47875 13.8474 4.61218 -0.893081 -14.6097 11.9436 +397 1 14.1162 7.44072 15.859 5.72353 -2.97717 1.52707 +398 2 14.8925 7.45204 15.2793 -3.03398 0.324075 5.79835 +399 2 14.4079 7.84098 16.6936 -1.38652 -1.7593 -3.67135 +400 1 2.91046 18.3824 1.92161 -14.6763 12.8451 -3.99897 +401 2 2.56811 17.7851 1.23066 -1.64793 1.84374 10.7046 +402 2 2.14175 0.293363 2.23042 22.3557 -16.8939 -8.97037 +403 1 8.00583 1.57089 4.46736 31.4122 8.97246 -10.4438 +404 2 7.40416 1.98491 3.8452 -8.42929 2.78546 -1.25861 +405 2 8.8818 1.75969 4.05638 -17.375 -7.71187 12.4181 +406 1 2.50572 14.1939 17.7606 -21.3738 -1.77578 0.320632 +407 2 1.88811 13.4733 18.0291 6.14349 16.4853 -5.08899 +408 2 3.36784 13.821 17.8832 22.941 -11.7322 7.4453 +409 1 0.984409 1.95477 13.9081 14.9076 0.866869 -10.4657 +410 2 1.09683 1.70126 14.8211 1.02253 -2.39927 14.2505 +411 2 18.6933 2.04344 13.7674 -16.8072 2.56857 -0.576968 +412 1 4.29327 0.177122 13.8951 16.4248 3.49785 -13.6548 +413 2 5.17049 18.4046 13.9646 -5.43827 4.9033 -2.01246 +414 2 3.78721 18.4389 14.598 -10.2443 -5.04864 16.3534 +415 1 7.35353 0.990853 18.4538 -34.7507 -7.39683 16.7648 +416 2 7.55815 0.737816 17.5561 -3.16307 -6.20953 -15.156 +417 2 6.35665 0.974064 18.6083 33.4978 7.02218 -7.3799 +418 1 15.8311 18.4256 13.8966 -40.0758 9.01377 -20.0242 +419 2 14.87 18.5763 13.7207 27.6408 -4.60797 -2.68704 +420 2 15.8417 18.2976 14.8321 10.6174 3.57585 21.6768 +421 1 10.2864 4.58419 16.2444 -24.4222 -37.2091 -9.88285 +422 2 11.2299 4.68793 16.3674 13.142 -4.29349 -1.09379 +423 2 10.1171 3.59079 16.124 8.18179 40.05 5.52806 +424 1 15.8917 17.7071 4.46459 -20.0388 -20.4222 2.09772 +425 2 16.4651 18.4471 4.57513 18.3163 24.2221 3.8588 +426 2 15.0409 18.0029 4.83395 4.42355 -1.752 -6.47073 +427 1 6.88773 17.6166 13.9821 -38.4037 0.167583 13.1844 +428 2 7.46394 17.6315 14.7417 15.8748 3.42447 12.5511 +429 2 7.41699 17.4009 13.2391 27.9809 -3.71977 -23.5355 +430 1 13.1764 6.43911 6.52144 -5.83912 -0.258919 -12.4557 +431 2 14.0695 6.77261 6.34605 -1.47407 -3.35023 -0.470203 +432 2 12.7466 6.3372 5.63472 11.513 2.45032 19.1456 +433 1 7.86196 2.29978 9.4638 -2.97627 -2.7765 -21.1046 +434 2 7.31086 2.09746 10.2267 -8.88065 1.6173 3.7395 +435 2 7.37564 1.98398 8.66115 7.69705 6.95472 18.2428 +436 1 15.1916 14.7366 13.8236 -12.2847 5.72199 -1.13466 +437 2 14.8954 15.0381 14.6996 2.36081 -1.57038 -3.3629 +438 2 14.579 15.1371 13.1848 7.3504 -2.29354 4.97967 +439 1 9.39483 8.42303 3.86324 -21.5436 -11.8424 -10.9865 +440 2 10.2164 8.84977 4.07537 16.3384 7.87643 5.27894 +441 2 9.57157 7.47345 3.83359 1.44741 0.673327 1.03302 +442 1 17.655 13.5671 16.4489 -7.58846 13.4511 -15.7424 +443 2 16.7203 13.3469 16.3992 -7.59268 -4.18946 5.70215 +444 2 17.688 14.4057 15.9472 10.2114 -8.11811 3.61388 +445 1 4.94979 10.486 2.86622 25.3355 -10.7625 -10.0508 +446 2 5.84023 10.0991 3.03563 -22.0316 6.96347 2.01482 +447 2 4.71704 10.9487 3.67532 0.603793 8.46932 2.75775 +448 1 3.68042 8.39717 9.8747 -7.87972 -17.3414 17.5888 +449 2 3.759 9.34077 9.71499 3.24219 9.53521 -0.886609 +450 2 3.55014 8.28216 10.8428 3.92085 5.02512 -16.6805 +451 1 15.9973 6.92061 5.87772 4.82031 -5.03924 3.59177 +452 2 16.6812 7.41263 6.34454 2.21588 0.961055 0.440265 +453 2 16.3186 6.0008 5.83915 -7.41322 12.2727 -5.03736 +454 1 15.3004 7.2666 8.94213 -32.1238 -12.1179 -31.7334 +455 2 15.9839 7.55437 9.51768 24.5834 17.5628 17.3411 +456 2 15.1488 7.91682 8.21973 7.72693 -8.10504 16.1569 +457 1 6.21705 12.8062 12.747 -22.7002 13.2796 -10.093 +458 2 7.05571 12.494 13.0465 21.6431 -16.5072 9.89045 +459 2 6.01919 13.5682 13.3077 2.09027 1.41895 1.21426 +460 1 12.1299 4.57596 13.1432 22.4432 17.9492 20.1123 +461 2 12.1793 4.58175 14.1216 4.56317 3.76233 -12.2652 +462 2 11.3861 4.04706 12.9369 -26.6961 -18.2025 -7.73732 +463 1 11.4375 8.07047 7.90979 27.6542 -15.5792 16.7856 +464 2 12.1952 7.52933 7.56059 -23.0528 10.899 -6.13628 +465 2 11.6627 8.11033 8.86659 -7.72222 6.32108 -19.0792 +466 1 16.9453 10.7968 7.63148 -3.5821 -10.5143 21.6719 +467 2 17.6495 10.1525 7.46889 2.86773 -0.504685 -4.5375 +468 2 16.8108 11.3218 6.85057 1.29813 10.4979 -20.4226 +469 1 5.19425 18.0282 10.6847 0.056878 3.62778 8.77145 +470 2 4.66571 17.4143 11.2104 4.95394 3.09506 -2.12913 +471 2 4.57063 18.3664 10.0251 3.33377 -5.62986 -0.929046 +472 1 7.60987 17.4226 1.56636 -8.76834 11.2024 10.6057 +473 2 8.12097 16.6429 1.35059 3.07922 -5.96866 -14.3061 +474 2 7.62904 18.066 0.842261 4.5937 -2.56699 -0.219584 +475 1 1.93734 12.9421 13.6328 4.51097 2.01356 -10.2989 +476 2 1.33249 12.4003 14.1383 -4.04092 -5.16916 8.28012 +477 2 2.1441 13.7105 14.1828 3.43289 -0.0153047 1.69165 +478 1 9.36109 6.77295 14.8254 28.0404 -16.4025 -23.0383 +479 2 9.79586 5.92856 15.0909 -10.7826 13.1246 6.51236 +480 2 9.73683 6.91972 13.9197 -17.1545 2.79671 17.5547 +481 1 15.2759 4.38629 10.7467 0.911226 -10.0818 1.35121 +482 2 16.2063 4.08729 10.7712 -9.28003 7.88291 1.38983 +483 2 15.15 4.95989 11.5268 6.34994 -5.62458 -10.0329 +484 1 11.4488 6.21672 0.0274361 8.35139 15.4334 1.07365 +485 2 11.547 5.26836 -0.0918922 -6.12153 -5.65013 -4.62095 +486 2 10.5221 6.46299 18.5238 -1.7877 -10.3718 -2.04901 +487 1 18.4903 11.4194 14.9121 8.77287 -18.4144 -27.074 +488 2 18.1021 11.8559 14.1353 -5.2902 0.217957 4.39134 +489 2 18.3331 12.0271 15.6113 -5.23497 22.6985 22.6894 +490 1 7.12593 9.28496 7.31024 -23.9992 -6.07508 6.39318 +491 2 6.74279 8.45494 7.66169 4.89732 10.9664 -5.80838 +492 2 8.06011 9.1434 7.29118 23.2007 -3.69072 -2.70719 +493 1 18.3302 15.3588 12.1663 1.84912 0.0598217 5.47138 +494 2 0.628985 15.4631 11.9685 -1.01298 4.74778 -2.81479 +495 2 17.8359 15.8974 11.5264 -1.18931 -3.22386 -0.556154 +496 1 16.5345 4.36456 5.22425 -62.6276 -15.6665 42.2949 +497 2 16.4135 4.0372 6.15475 14.4043 4.47956 -24.0603 +498 2 17.4334 4.499 5.03806 48.2264 1.34274 -11.6623 +499 1 17.733 3.12037 10.7685 2.78093 13.2032 15.2159 +500 2 18.62 3.27348 11.1411 -3.87004 4.46435 -8.2182 +501 2 17.7411 2.21797 10.4818 -1.03268 -21.1847 -12.2715 +502 1 12.2988 18.6545 10.1426 21.4258 -12.4002 -10.8053 +503 2 11.5002 0.459945 10.3706 -28.4452 4.23152 6.39845 +504 2 12.9389 0.72089 10.1511 12.8533 4.08749 0.539844 +505 1 10.4313 9.72872 12.541 3.98701 -3.38274 8.58973 +506 2 11.1703 9.84044 13.1623 -1.01011 3.74187 -3.45859 +507 2 10.4039 8.77038 12.4204 -3.66163 0.188688 -4.07709 +508 1 0.615048 2.63664 7.2276 -9.26807 24.3162 -18.5585 +509 2 0.353188 3.56967 7.37092 2.19049 -16.4853 1.00686 +510 2 0.949026 2.32684 8.06684 4.15829 -4.72879 9.31366 +511 1 0.333537 15.2707 6.93805 -1.63763 -14.4268 -44.2284 +512 2 0.559673 15.3175 7.85021 9.94673 -3.51892 30.6084 +513 2 0.629693 14.3791 6.62643 -7.55161 17.6489 9.10591 +514 1 17.0527 6.91364 14.9743 11.0217 0.359412 -1.38417 +515 2 17.7989 7.54943 14.9113 -7.11537 -10.2599 3.19545 +516 2 17.3979 6.08953 15.3732 -1.90278 10.2985 -1.25317 +517 1 9.14167 12.5321 7.98456 -51.8007 8.58975 -7.36144 +518 2 9.48882 11.7504 7.57305 13.8522 -18.8219 -15.7166 +519 2 8.22261 12.6161 7.58551 34.0094 -0.937982 16.6367 +520 1 1.15656 1.63828 2.76743 -9.76481 2.77041 -4.10292 +521 2 0.864287 2.18836 2.03128 -7.19413 -5.97378 -5.55322 +522 2 1.70002 2.22125 3.28253 11.7483 7.29404 14.7886 +523 1 4.17339 15.1305 9.84913 -14.3711 5.0779 2.99988 +524 2 3.91961 15.3463 8.93389 10.9385 -4.50851 5.90843 +525 2 5.03476 14.6902 9.78793 -0.575875 2.49321 0.528438 +526 1 7.3951 2.27992 14.8377 -1.12966 16.8522 -8.99686 +527 2 7.16414 1.54106 14.2639 1.26623 0.276941 -0.531744 +528 2 7.65338 3.03331 14.2573 -5.05472 -19.0282 8.30824 +529 1 18.3172 14.5403 2.1483 15.3986 5.40572 3.08201 +530 2 0.535799 14.8642 2.50804 -16.0996 -1.12956 -11.071 +531 2 17.7238 15.3001 1.99479 6.48993 -0.927096 4.3539 +532 1 10.0475 2.68059 12.9077 -3.02015 -13.9614 -15.6621 +533 2 9.89167 2.00033 12.2018 7.6523 15.7956 13.7679 +534 2 9.26985 3.25658 12.875 1.66072 1.15674 0.355625 +535 1 2.93978 8.85687 13.107 17.7725 7.3386 -7.69378 +536 2 3.37522 9.71823 12.8547 -12.3312 -24.1388 6.15133 +537 2 3.67473 8.22279 13.2377 -8.38529 8.44125 1.12687 +538 1 3.27106 8.61507 3.79074 -8.49716 -38.7584 59.7131 +539 2 3.66196 9.22584 3.22278 26.3747 36.1018 -32.8858 +540 2 3.70281 8.77413 4.67945 -18.9434 -3.96308 -29.2422 +541 1 5.92777 7.2521 8.64891 -10.8881 -6.62505 3.42768 +542 2 5.84919 6.30478 8.465 1.79189 -1.90292 -1.42585 +543 2 5.07694 7.48175 9.0605 5.83384 2.94932 1.14829 +544 1 14.8827 1.64134 1.82872 -12.6885 -28.1567 -9.76357 +545 2 15.1087 2.39997 2.36476 0.314968 13.4446 -1.58597 +546 2 15.1034 1.73075 0.884031 8.80659 10.9019 15.543 +547 1 8.66156 14.9913 0.655877 15.6167 -4.79217 23.7466 +548 2 9.42437 14.9505 1.28455 -14.0351 0.988592 -13.753 +549 2 7.99981 14.403 1.0655 -3.22335 6.28365 -6.24421 +550 1 15.4067 1.46647 7.20695 -8.82589 -12.8718 -0.882757 +551 2 14.775 0.932663 6.69065 9.74374 4.52972 3.50353 +552 2 14.8641 2.16562 7.57814 -1.0399 11.0322 0.525673 +553 1 4.92475 12.8978 18.4559 2.19674 -3.23744 10.1082 +554 2 5.23586 12.8997 0.738081 -1.33722 2.66651 -10.6279 +555 2 5.70033 13.1343 17.9365 -0.0827318 6.23371 -0.0935372 +556 1 15.3819 8.68528 18.0932 8.72121 10.5448 -14.8557 +557 2 15.8142 9.23534 17.405 -7.78496 -12.8196 8.73029 +558 2 15.2566 9.31777 0.164984 -6.85428 -0.586954 10.5179 +559 1 12.0126 3.13082 18.276 9.47145 -1.72319 12.159 +560 2 12.2482 3.16999 0.564179 -5.55591 0.644277 0.165862 +561 2 12.5655 2.41012 17.9461 -5.90061 -0.236568 -11.7395 +562 1 13.2006 12.6959 5.14014 6.0546 -4.02499 4.06103 +563 2 13.6294 11.8271 5.0147 -6.69767 7.2237 -2.15456 +564 2 13.3727 12.9234 6.07289 -1.67526 -4.52376 -7.3865 +565 1 6.1651 7.14436 0.195504 -22.0894 -12.2339 1.18179 +566 2 6.12052 8.09409 18.9477 10.183 13.9972 -1.43251 +567 2 5.2591 6.87987 0.448218 12.567 -4.05161 -1.41715 +568 1 17.6881 15.878 14.8655 -1.85909 5.77814 22.6605 +569 2 16.7739 16.1608 15.0761 11.3822 -6.39517 -19.8211 +570 2 17.8371 15.675 13.9293 -11.1648 4.64831 -4.02463 +571 1 13.1067 0.88062 16.8301 -1.16362 5.09418 6.26073 +572 2 14.0188 0.56665 16.8428 4.80395 1.33473 -1.08149 +573 2 12.5822 18.7235 16.7479 -0.784604 -6.20947 -5.79489 +574 1 10.8701 14.5014 7.48366 30.6398 4.5327 -13.288 +575 2 10.1924 13.8927 7.76637 -8.27046 -6.89901 6.40521 +576 2 11.688 13.9665 7.40985 -13.0568 5.23738 5.47236 +577 1 17.7216 8.3975 2.13341 -5.03714 18.392 15.6468 +578 2 16.8261 8.35978 2.51012 1.26608 -2.81583 -3.60077 +579 2 17.7343 7.78208 1.41002 -5.68948 -14.3091 -15.2975 +580 1 12.4651 7.83121 2.02849 6.21002 21.8293 -0.701234 +581 2 12.2371 8.77742 1.88873 1.61752 -16.1639 -0.0618129 +582 2 12.1801 7.35781 1.23988 -4.06145 -2.69746 -4.32972 +583 1 11.9912 14.5504 10.3779 26.255 2.08103 -27.6641 +584 2 12.3772 14.5828 9.46952 -12.6474 -4.22617 24.8662 +585 2 11.0517 14.669 10.2537 -15.8484 3.20565 2.09431 +586 1 6.76727 6.87556 15.5462 0.393734 11.8444 22.477 +587 2 7.69535 7.12306 15.3658 -7.56189 -7.86407 -0.973014 +588 2 6.54154 7.32616 16.388 3.13619 -10.9433 -13.6985 +589 1 7.93405 4.43454 13.181 3.70457 37.9343 33.3332 +590 2 7.23909 4.66367 12.5613 -7.79541 1.00974 -8.53955 +591 2 7.95717 5.24214 13.788 5.6586 -32.0049 -23.1645 +592 1 13.3208 12.2124 14.3278 -1.85908 1.78375 8.34338 +593 2 13.1627 11.2597 14.246 -0.36998 0.633125 0.823702 +594 2 13.6236 12.4909 13.4584 3.579 0.31603 -3.71376 +595 1 14.5678 9.48203 7.30395 8.22624 -5.55489 -6.16459 +596 2 15.3274 10.0218 7.53849 6.73854 1.05081 2.13221 +597 2 13.8344 9.86252 7.77014 -14.2105 5.15772 9.40205 +598 1 12.6689 16.8584 3.2838 3.32354 22.4122 -6.02395 +599 2 12.8251 17.4603 4.02708 -0.185303 -8.85949 -0.0347213 +600 2 12.7374 17.4469 2.50984 -1.71014 -6.46341 4.85536 +601 1 0.984375 7.0735 17.3432 34.0501 -3.91376 2.11413 +602 2 0.125246 6.96907 17.7347 -25.3968 2.18392 3.09576 +603 2 0.950307 7.67775 16.5933 -9.77339 5.8232 -4.41721 +604 1 13.0022 4.84407 15.777 5.081 -10.3329 -5.56354 +605 2 13.7485 4.25418 15.5901 -10.0146 -2.33354 7.04552 +606 2 13.4521 5.67804 15.8535 -1.12386 24.7122 1.66863 +607 1 2.36131 3.40053 5.10919 -9.6311 -14.0051 -9.38531 +608 2 1.85776 3.14724 5.88615 -5.89279 -11.6191 4.05299 +609 2 2.64546 4.27356 5.34111 14.5219 19.3293 2.74972 +610 1 8.16093 10.9198 13.7208 -5.48668 -10.5203 36.1407 +611 2 8.01338 10.5218 14.6488 11.4544 18.6016 -43.3573 +612 2 8.9553 10.5154 13.3405 3.89898 -1.19123 3.66799 +613 1 13.0685 1.50992 13.279 -14.1832 25.7313 -25.8855 +614 2 13.6244 1.50815 12.4613 -6.9447 -4.36872 19.5281 +615 2 12.4297 2.25673 13.1075 20.3356 -25.0236 11.2619 +616 1 6.62047 13.6375 2.07221 -5.18984 1.0977 1.00923 +617 2 6.01355 14.0796 2.67998 -4.17105 4.32933 -3.39809 +618 2 7.10668 13.0566 2.65885 8.90022 -6.51269 2.26225 +619 1 15.8066 6.3469 12.5124 13.7748 11.2213 20.1038 +620 2 16.2844 6.87459 11.8544 0.57451 -1.64399 2.92177 +621 2 16.2805 6.52872 13.3684 -12.0243 -5.9969 -18.7155 +622 1 16.7622 0.649503 9.5351 11.3629 -0.534141 16.2257 +623 2 16.8233 18.3334 9.63984 -7.20854 -2.096 2.62458 +624 2 16.3504 0.825019 8.69009 -8.20455 0.909068 -17.3039 +625 1 6.16155 11.6721 8.23727 11.0478 -14.7079 4.32064 +626 2 5.37204 11.4355 8.7099 -18.5694 3.37101 8.66714 +627 2 6.52549 10.7898 8.06052 6.85938 7.24602 -7.48704 +628 1 2.80718 8.60686 0.397493 -27.1124 -12.7057 -15.0387 +629 2 2.16203 8.12721 18.4284 20.3601 19.9434 23.0266 +630 2 2.28863 9.2379 0.937046 1.66532 -5.5958 -10.4069 +631 1 10.1061 10.2794 6.574 -2.68384 6.39054 8.98367 +632 2 10.587 9.61275 7.07222 2.60765 -6.52577 4.24337 +633 2 10.6348 10.4062 5.77746 -5.53346 0.236498 -3.27199 +634 1 6.84319 15.7735 6.74802 2.92919 -7.52667 3.13791 +635 2 7.22287 16.2754 7.48672 -6.2609 -2.86584 0.474311 +636 2 7.16745 16.2182 5.95944 -1.73758 9.59963 -7.48558 +637 1 6.59004 12.8453 5.92771 5.9232 5.70246 -10.7633 +638 2 6.81648 13.7523 6.14266 -3.08056 9.02497 3.95142 +639 2 6.18071 12.4806 6.71128 -2.95494 -1.85994 5.08984 +640 1 16.7187 12.5557 9.81602 -6.97981 -8.42056 3.44329 +641 2 16.7367 11.9049 9.10465 3.04519 -4.31121 0.702836 +642 2 17.0063 13.3635 9.40922 2.88649 12.8114 -1.84814 +643 1 6.30344 2.78963 2.73877 -9.04367 -13.9111 -2.70816 +644 2 6.4136 3.72217 2.50807 2.58545 1.58307 -3.30667 +645 2 5.8765 2.3355 1.98292 3.38351 11.0448 5.4768 +646 1 10.696 2.92954 3.25253 -4.78239 0.546409 -3.48797 +647 2 10.285 3.77274 3.47459 -3.26512 -0.523652 -3.33277 +648 2 10.2907 2.61783 2.41902 1.90367 1.74508 6.25714 +ITEM: TIMESTEP +100 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.7952 6.55188 17.82 -14.0925 -19.7636 -3.75378 +2 2 7.88023 6.44026 18.1695 19.5523 6.07432 -5.80163 +3 2 8.99571 5.7855 17.2401 -2.64216 11.7935 9.74201 +4 1 0.13387 8.39658 6.71777 11.0686 -17.0219 51.8315 +5 2 0.297964 8.15416 5.82611 3.65759 -8.78146 -34.4276 +6 2 0.663997 7.73523 7.26654 -21.1289 27.238 -19.6589 +7 1 8.71966 0.469223 7.04147 6.63626 1.40123 -3.67752 +8 2 9.62406 0.435013 6.6778 -11.0722 1.83914 2.93454 +9 2 8.2146 0.970711 6.38506 4.19741 -2.20649 2.49068 +10 1 6.44826 1.6863 11.7796 22.1018 -16.0737 -10.0998 +11 2 5.81214 2.23354 12.2013 -20.9633 15.3476 12.0772 +12 2 6.02072 0.836228 11.6256 -4.8988 -3.15305 -3.34718 +13 1 6.89097 5.45035 2.38694 -14.0878 18.1315 0.804401 +14 2 6.23022 6.01625 2.92115 27.2653 -21.4077 -23.7527 +15 2 6.91491 5.77412 1.45583 -9.40281 2.39732 25.4334 +16 1 16.2334 10.2315 16.0664 1.22095 -12.8583 -8.35396 +17 2 17.1105 10.2758 15.679 0.521344 2.88453 0.293596 +18 2 15.9464 11.1361 16.1778 -3.48259 10.2735 3.78324 +19 1 10.8573 15.0007 2.35193 -8.17785 -20.274 -7.01899 +20 2 10.8024 14.5151 3.19219 -3.98998 0.859093 -1.88791 +21 2 11.3201 15.8014 2.5578 8.92048 16.4226 10.3474 +22 1 17.1726 8.21805 11.024 14.0848 -19.0512 -23.2094 +23 2 16.691 8.91369 11.4632 -8.36385 12.6057 9.94503 +24 2 17.8921 8.64427 10.518 -5.71892 -0.131476 8.97419 +25 1 14.5956 15.9799 16.3132 20.7515 -13.8502 3.42179 +26 2 13.7469 16.3872 16.1713 -21.6627 3.23661 7.28294 +27 2 14.5521 15.3865 17.0935 -1.40849 8.21009 -3.21798 +28 1 12.1509 13.2395 0.573493 6.57205 3.5904 2.72349 +29 2 11.837 13.3986 18.3303 -3.80405 -1.74926 -15.723 +30 2 11.7012 13.9105 1.09717 -2.12612 0.929616 9.94365 +31 1 9.32377 5.48511 3.80515 37.2224 0.919853 24.8976 +32 2 8.88878 5.295 4.65312 -11.8166 2.00864 -7.28102 +33 2 8.70235 5.44743 3.10202 -35.0307 -2.6733 -15.0358 +34 1 1.53449 3.88906 11.5762 -21.4592 42.8438 -26.3691 +35 2 1.39761 4.77552 11.9865 7.05639 -9.88004 -9.22537 +36 2 1.89707 3.34621 12.2331 21.1403 -27.4328 37.6181 +37 1 2.11621 6.94729 8.0812 -5.52003 -16.2776 -1.04121 +38 2 2.5746 7.45442 8.7366 8.45236 15.6822 11.2536 +39 2 2.08388 6.07661 8.50513 -4.57751 -6.44388 -7.47435 +40 1 5.24695 4.43578 7.8028 -6.30612 26.2857 -2.69952 +41 2 5.36677 3.49844 7.65426 0.215716 -12.5366 -1.65761 +42 2 4.56392 4.76953 7.18377 10.1949 -9.65667 2.91339 +43 1 3.43524 2.88686 17.4376 -21.7675 5.87472 14.6558 +44 2 3.90981 3.17382 16.6701 17.8952 10.4272 -14.0542 +45 2 2.87759 3.6541 17.6984 8.18662 -9.04753 2.1829 +46 1 7.55778 5.57378 6.15352 3.99821 9.40639 19.9011 +47 2 8.12518 6.20749 6.66299 -12.9927 -14.0765 -9.88952 +48 2 6.98227 5.15891 6.82729 7.75312 -1.10557 -10.9113 +49 1 9.77611 7.00478 12.0482 -6.90333 -2.64414 -8.04886 +50 2 10.0224 6.11753 11.7611 0.642082 2.81741 -0.891425 +51 2 9.0843 7.2891 11.4183 2.80801 -0.947675 5.79882 +52 1 14.1423 3.90191 8.16294 -23.6925 4.35767 -24.2753 +53 2 13.5235 4.53411 7.72337 18.2577 -11.8103 7.89417 +54 2 14.4024 4.31063 8.97869 6.95814 7.70003 16.5888 +55 1 4.54437 17.2359 3.8519 4.03565 10.1791 3.31349 +56 2 5.34213 17.7268 4.08304 4.36901 -6.62302 -0.267376 +57 2 4.17051 17.7127 3.09453 -6.96766 -2.87365 4.53203 +58 1 16.1339 16.4921 10.5971 24.4543 -12.0388 -34.7313 +59 2 15.4578 16.6815 11.2098 -23.1752 5.77424 26.3474 +60 2 15.6745 15.9439 9.92709 9.81353 9.26167 7.23238 +61 1 1.98282 4.87023 -0.0102057 11.328 -31.2723 15.691 +62 2 2.56866 5.25094 0.666382 -3.10152 5.14206 -1.69339 +63 2 1.65849 5.5885 18.1127 -8.58794 22.0564 -11.6074 +64 1 11.0975 13.3336 16.4568 21.334 -26.4555 -13.6253 +65 2 10.7319 12.43 16.5661 -7.83355 14.7592 4.38577 +66 2 11.7328 13.1734 15.7328 -3.59268 8.82171 6.12988 +67 1 9.983 10.9188 16.8195 21.8027 -17.9597 14.5818 +68 2 10.5015 10.1139 17.0687 -12.258 16.9146 -11.8156 +69 2 9.08607 10.6082 16.6912 -8.94921 1.38614 -3.26281 +70 1 11.9148 17.5563 13.4787 -11.9158 -12.5975 -1.23623 +71 2 12.5676 17.2101 12.8515 -0.0246338 2.67811 4.16536 +72 2 12.0003 18.5089 13.4756 8.75914 10.3848 -3.31648 +73 1 6.43245 9.54572 12.2957 1.63429 -3.34072 -14.2423 +74 2 7.08046 9.15867 11.6656 -10.0512 7.63496 6.98562 +75 2 6.90317 10.1892 12.8448 2.76093 -9.73394 -7.4892 +76 1 16.2985 12.7819 2.78073 -6.76278 9.02259 -0.251856 +77 2 17.1507 13.1937 2.56739 -3.11425 -2.92719 1.79117 +78 2 15.6658 13.5347 2.78258 7.1706 -12.5209 -0.796151 +79 1 0.705375 12.7757 5.80641 -31.4327 0.785322 -26.0818 +80 2 0.964058 12.7408 4.86595 9.86444 -3.28161 8.94612 +81 2 18.3663 12.6813 5.72517 19.7421 -2.33124 11.5636 +82 1 5.30386 16.3127 18.466 5.80758 -1.43031 -6.37222 +83 2 5.80257 15.6526 17.9366 -5.42534 13.184 13.7491 +84 2 5.92544 16.7092 0.45256 -3.43112 -6.46136 -2.11967 +85 1 0.781035 7.63768 4.09742 11.023 -5.93732 13.9838 +86 2 0.258202 7.96457 3.37539 -14.755 3.95315 -10.1558 +87 2 1.66078 7.97253 3.8829 3.26007 -0.00880383 4.41534 +88 1 3.24417 9.16605 6.56429 -20.4701 -14.3326 2.83801 +89 2 3.57159 8.65908 7.31953 1.49107 7.58135 -6.52778 +90 2 2.30098 8.88971 6.4655 20.5558 12.7829 2.43715 +91 1 7.26627 10.4004 16.2591 -15.7562 -6.32656 27.9079 +92 2 6.82075 11.2368 16.4586 5.73239 -2.42146 -6.93429 +93 2 6.93167 9.82605 16.9811 6.22417 8.86745 -10.8084 +94 1 10.9892 0.849679 5.07849 4.12027 -5.76689 -13.93 +95 2 11.0513 1.64213 4.53259 0.725375 9.02843 9.39609 +96 2 10.6504 0.238952 4.4041 -0.868918 -3.08012 11.6628 +97 1 4.18223 2.98976 13.1617 1.80285 -9.79496 -4.9743 +98 2 4.46754 3.28562 14.0477 -4.0491 -7.36491 -7.89898 +99 2 4.03841 2.01285 13.1683 3.67857 16.3758 11.7633 +100 1 8.4888 10.2856 1.85141 10.3375 -10.6918 -8.28538 +101 2 8.43451 10.9691 2.52904 -3.58901 -0.686288 7.94652 +102 2 8.82874 9.48425 2.29142 -6.1923 10.8646 1.43904 +103 1 10.2336 1.64305 15.4458 -13.2429 9.10796 4.38269 +104 2 11.1732 1.63861 15.572 16.9305 -2.55664 -1.17381 +105 2 10.0536 2.05804 14.5895 6.55462 -3.46994 -1.37038 +106 1 2.58993 12.7242 7.97336 -7.23425 -8.94691 3.8681 +107 2 3.01571 13.5704 7.82234 5.57764 5.06786 -6.45979 +108 2 1.98486 12.5774 7.23174 0.806159 4.05811 0.362671 +109 1 3.90685 11.8307 5.02738 -19.955 -7.05304 -0.3571 +110 2 3.70751 11.1281 5.68153 3.09094 12.242 -8.4391 +111 2 3.06715 12.0092 4.53628 19.8771 -7.15241 7.2697 +112 1 6.7679 14.5791 16.9276 2.77817 -6.983 11.0716 +113 2 7.71708 14.7379 16.9268 0.980214 1.28706 0.809355 +114 2 6.44853 14.8723 16.076 -0.709014 -5.22289 -12.1565 +115 1 14.1752 14.508 3.1348 7.33594 -12.7834 -7.22412 +116 2 13.6105 15.2801 3.10139 -3.55206 9.35654 4.80996 +117 2 13.7682 13.8754 3.73922 -4.33905 3.15851 6.00261 +118 1 8.77346 18.0937 16.1268 -49.3086 -19.2657 7.09896 +119 2 9.29148 17.2891 16.2682 10.0054 9.31596 -1.94744 +120 2 9.22615 0.228463 15.833 27.8858 8.66202 -5.29688 +121 1 4.63977 1.75161 4.89947 12.6555 12.3233 -26.7382 +122 2 3.82082 2.25711 4.97207 0.159842 -3.07614 2.23584 +123 2 5.05477 2.09313 4.05862 -7.26402 -10.6651 28.8422 +124 1 15.0293 12.6717 16.5117 -23.31 -0.861404 35.6256 +125 2 14.4426 12.7177 17.3057 24.815 2.28331 -11.4604 +126 2 14.393 12.496 15.8301 -9.60755 -0.359254 -28.8722 +127 1 15.7282 18.4115 16.8424 17.2085 30.6847 -2.58542 +128 2 16.585 18.5255 17.3163 -17.0651 -10.3906 -2.34083 +129 2 15.5073 17.4884 16.7844 1.64687 -19.4864 2.05956 +130 1 1.3653 1.32145 16.674 4.57571 12.7751 22.4809 +131 2 2.22966 1.72757 16.8986 -13.3853 -7.67206 -8.47788 +132 2 0.843747 1.53379 17.4789 2.23908 -6.3926 -16.4011 +133 1 18.2502 4.28823 15.9426 5.59379 -7.24598 -18.3859 +134 2 17.8025 3.49471 15.6029 3.53909 11.4984 4.55434 +135 2 0.380345 4.42598 15.3659 -10.3938 -1.91133 11.4 +136 1 12.0179 17.0993 16.1449 -24.7595 -29.8482 27.6473 +137 2 11.2904 16.5264 16.5371 30.7476 29.6052 -3.96723 +138 2 11.7854 17.0696 15.2267 4.30162 8.23296 -25.5613 +139 1 16.0455 2.77586 18.2041 10.6955 -6.31261 -1.53201 +140 2 15.9135 3.65525 18.5895 -10.0784 -5.09061 -10.2232 +141 2 15.7148 2.7749 17.2908 -2.70848 4.2718 2.75475 +142 1 6.57887 13.7167 10.0128 0.388305 24.4332 24.1101 +143 2 6.2636 13.3347 10.8463 6.37938 -3.40375 -0.55213 +144 2 6.43171 13.0818 9.3305 3.17506 -19.669 -12.997 +145 1 10.1062 18.565 2.71626 12.0596 2.32822 -17.6158 +146 2 10.7563 0.294125 2.0815 -9.9929 -7.47975 8.60443 +147 2 9.2984 18.4331 2.20633 -1.12272 -0.999648 5.59115 +148 1 3.10044 17.6571 6.21769 -0.590198 -1.20238 18.0356 +149 2 2.16339 17.7471 5.9649 14.558 -0.242179 -11.811 +150 2 3.6505 17.6877 5.42436 -8.00238 0.252249 -9.63341 +151 1 12.5899 16.7797 7.85568 11.434 -9.28582 -14.859 +152 2 11.8995 16.1049 7.73478 -4.76829 8.38316 1.604 +153 2 12.3367 17.3735 8.55676 -7.89443 8.69289 16.0625 +154 1 14.8958 15.3252 8.42405 -10.9907 16.0866 -10.412 +155 2 14.2257 15.9607 8.05927 9.60746 -16.915 15.6813 +156 2 15.568 15.2992 7.73812 1.83068 -0.846784 -8.90808 +157 1 17.9236 18.2959 0.16927 -20.6229 -20.5305 -14.2597 +158 2 18.7101 17.7336 18.8116 8.98564 4.8691 -3.01699 +159 2 18.0908 0.428516 0.675884 12.0916 17.8267 11.1415 +160 1 0.800533 10.4853 1.48213 -15.9305 -52.1134 32.1201 +161 2 0.0210499 9.87138 1.72712 35.348 27.3948 -12.4938 +162 2 0.488783 11.092 0.839839 -12.4886 25.7711 -24.5144 +163 1 1.85398 12.3107 3.26054 -2.39029 3.71051 2.5874 +164 2 1.61156 11.5651 2.68837 -2.80207 3.45241 0.205878 +165 2 2.01622 13.0664 2.66785 -2.08994 -5.59574 4.32216 +166 1 0.726068 17.2941 4.97534 23.1964 8.93599 -27.6283 +167 2 -0.00504426 17.9045 4.96895 -11.3657 3.83105 9.40925 +168 2 0.6848 16.6356 5.64734 -16.8394 -17.6158 22.5419 +169 1 0.979774 0.931094 9.39103 18.34 6.67236 9.68687 +170 2 1.13606 0.587208 10.3041 -6.25966 0.627701 -15.4141 +171 2 0.222638 0.493139 9.00427 -6.20505 -6.29115 6.11619 +172 1 16.8132 2.44689 13.4524 12.1018 18.2567 -5.29927 +173 2 16.9941 2.74318 12.5312 -5.60486 -9.11594 12.8952 +174 2 16.5475 1.52939 13.4414 -4.39811 -15.2301 -8.28386 +175 1 2.68823 16.0572 12.0971 4.35106 -7.5731 1.60029 +176 2 3.00862 15.6347 12.9147 -3.00711 3.68751 -12.4652 +177 2 3.25289 15.7623 11.3532 -3.53001 -2.50035 7.7005 +178 1 16.365 15.3972 6.07793 1.10786 -2.726 6.22736 +179 2 17.2616 15.5854 6.39959 0.338369 -3.43469 -2.74975 +180 2 16.1217 16.1306 5.49548 2.77772 2.55878 -2.13745 +181 1 5.71885 5.23685 11.7571 -1.38587 -22.0348 -7.59079 +182 2 5.34065 5.94353 12.2818 1.95161 11.9795 4.35233 +183 2 5.13977 4.47517 11.9216 1.17844 4.76848 -1.31072 +184 1 15.1029 4.9502 0.771222 1.99697 3.13949 16.3358 +185 2 15.0181 4.74755 1.72068 1.03511 -0.706475 -1.64751 +186 2 14.2572 5.32925 0.539529 -7.17443 2.24029 -6.36177 +187 1 16.4241 16.5209 1.77175 11.7834 22.2537 -31.9797 +188 2 16.1353 16.901 2.59837 -3.82757 4.70614 16.3909 +189 2 16.7243 17.3043 1.2165 -7.10171 -29.7856 17.5505 +190 1 0.166785 4.90105 4.02875 -9.807 6.14851 -6.2016 +191 2 0.490919 5.80972 4.19933 1.47178 -10.2493 -2.87817 +192 2 0.85797 4.25703 4.16889 13.481 4.94217 6.1798 +193 1 2.95388 15.1092 15.162 10.7369 -8.35154 -8.83455 +194 2 2.79081 14.8128 16.074 0.0767364 3.70074 1.09557 +195 2 2.55949 15.9866 15.0864 -8.26758 5.41964 7.36053 +196 1 1.08589 14.7081 9.5149 24.8711 -1.95174 9.92838 +197 2 2.02655 14.926 9.73253 -22.6422 -7.57261 -8.5802 +198 2 0.981604 13.769 9.74603 1.17561 7.47496 0.770389 +199 1 13.5787 16.5188 11.5692 -12.2314 13.2219 -8.78769 +200 2 13.3397 17.246 10.9551 -0.181138 -8.24863 9.65793 +201 2 12.9892 15.7954 11.3146 2.83531 -7.80051 -5.41791 +202 1 4.81777 1.55092 0.678258 -26.6156 -3.92273 4.29753 +203 2 4.35705 2.21925 0.160828 3.99581 1.83661 -5.90848 +204 2 4.05187 1.04139 1.04246 22.8613 -3.7169 0.169547 +205 1 1.54475 18.6679 11.892 -7.41525 16.2224 7.56704 +206 2 1.47416 0.586534 12.6867 1.33096 -5.97454 -6.01551 +207 2 1.79005 17.7987 12.209 7.72027 -7.46968 0.191542 +208 1 11.4358 10.1471 4.23265 -10.894 -3.87129 -8.35951 +209 2 11.2613 10.4034 3.31126 9.28636 4.56211 3.82985 +210 2 12.3915 10.0236 4.32197 -4.85978 3.43988 -0.432274 +211 1 8.20336 12.1359 3.88849 -13.0458 16.1374 35.7669 +212 2 8.99874 12.5954 4.16275 16.0075 -1.33649 -14.8839 +213 2 7.69556 12.2697 4.73273 -2.96338 -15.3566 -29.2591 +214 1 14.5957 4.06338 3.37559 11.9385 -4.24509 -11.5663 +215 2 15.1907 4.01381 4.14053 1.35901 4.80596 -1.61984 +216 2 13.7786 4.41816 3.71066 -15.4173 6.10577 6.17301 +217 1 5.71905 1.6749 7.61995 8.80947 6.26404 67.7498 +218 2 5.099 1.08549 8.07836 1.13728 7.44943 0.131268 +219 2 5.55556 1.51371 6.73852 -13.1925 -8.9768 -74.4163 +220 1 17.8986 1.04478 4.82737 2.1754 -1.83476 -0.744307 +221 2 18.4917 1.14925 4.06283 -1.19754 2.46044 8.41233 +222 2 18.3052 1.49477 5.5864 -1.29774 -0.0865267 -3.68542 +223 1 6.84138 9.15652 4.5536 4.1666 1.31036 -3.45285 +224 2 6.90548 9.53593 5.43168 -5.85674 1.32054 6.56912 +225 2 7.76285 8.95875 4.34348 -1.51129 -0.833856 -3.18299 +226 1 2.51554 14.7147 2.08788 -0.0450507 -1.43316 -6.26715 +227 2 3.18184 14.7861 2.78103 3.7873 -1.55841 0.251503 +228 2 3.00277 14.5163 1.27395 -5.30581 6.45149 3.77223 +229 1 17.2192 13.0031 13.0554 -12.0926 -3.19634 4.57291 +230 2 16.3553 13.3969 13.3572 27.3304 0.34804 -8.60607 +231 2 17.7786 13.6982 12.6582 -16.3476 4.90844 7.68697 +232 1 14.8182 10.5634 1.61386 4.26778 13.3748 6.0388 +233 2 15.4677 11.1895 1.9919 -6.32062 -5.48184 -5.48699 +234 2 13.979 11.0422 1.62876 3.88819 -6.35193 -1.63244 +235 1 5.61579 6.74404 4.50101 -16.4591 -25.6922 -2.42498 +236 2 5.98931 7.61359 4.54862 8.72135 21.7956 -0.434523 +237 2 6.18395 6.1944 5.05334 5.89398 3.69136 0.98365 +238 1 7.99723 8.25195 10.2692 14.8304 8.84149 10.0706 +239 2 8.65992 8.88256 9.91656 -9.90097 -8.80766 -1.78449 +240 2 7.59566 7.7759 9.52484 -1.48617 9.19501 4.49734 +241 1 13.4628 18.4324 5.71378 17.6235 1.75148 -9.47684 +242 2 12.708 0.350866 5.56458 -19.7852 7.87128 -2.36248 +243 2 13.2811 17.9777 6.53219 -7.30606 -12.1428 7.93723 +244 1 0.0668655 2.55772 0.44163 -1.64079 -15.5797 1.12414 +245 2 17.7792 2.62308 0.158326 7.01821 10.3157 -4.2768 +246 2 0.560589 3.37114 0.261458 -5.35649 7.7487 -2.70304 +247 1 12.8473 10.8167 9.6749 -29.1069 48.3462 -20.1155 +248 2 11.856 10.995 9.62541 32.1605 -20.6147 5.13184 +249 2 13.0142 9.92242 9.94244 -8.5776 -22.9331 5.75343 +250 1 0.607197 12.3488 11.1216 10.7177 -2.21067 3.69277 +251 2 18.3016 12.4338 11.1296 -15.0263 -0.672926 -5.71109 +252 2 0.887353 12.7089 11.9725 7.71276 -2.01358 -2.19338 +253 1 5.32001 7.36668 13.2938 5.32433 15.1635 7.63099 +254 2 5.70557 8.20602 12.9842 -2.91102 -7.98825 -6.07053 +255 2 5.82609 7.21997 14.1065 -9.96591 -5.08448 1.55341 +256 1 1.1733 6.74916 11.943 -30.749 -23.7015 -12.6924 +257 2 0.265139 7.01822 11.7017 14.0517 -0.957096 2.97943 +258 2 1.61086 7.53614 12.2133 15.6557 23.6476 13.031 +259 1 15.5486 9.75906 12.4999 -0.653644 29.4777 3.96245 +260 2 15.1521 10.5891 12.1135 7.41979 -25.1975 16.8694 +261 2 15.9641 10.0301 13.3422 -9.48671 -5.05259 -12.6364 +262 1 16.5044 12.5382 5.51299 -3.50049 1.7151 -41.7779 +263 2 16.2902 13.4721 5.54585 0.30498 11.7411 21.1442 +264 2 16.3754 12.4207 4.53497 7.77761 -11.637 24.1999 +265 1 6.32544 9.92844 0.21289 -23.4091 -5.64021 -11.1485 +266 2 5.58447 10.3552 0.689761 9.59747 -6.57127 -5.34636 +267 2 7.10511 10.1371 0.71679 14.7949 3.34633 14.2781 +268 1 12.1134 5.97718 4.01208 -22.8865 -14.7559 9.656 +269 2 12.2541 6.73773 3.46345 4.76282 13.7738 -16.8186 +270 2 11.1454 5.80116 3.92348 22.2207 -1.187 3.16864 +271 1 0.310021 12.9061 0.00438974 -4.95288 1.79463 -7.14095 +272 2 18.578 13.473 0.695812 6.768 -1.51286 0.947724 +273 2 18.4929 13.1888 17.8371 0.864006 -6.25549 9.7975 +274 1 3.57649 0.0893425 8.67318 10.7138 1.44606 -23.5182 +275 2 3.53585 18.3471 7.78602 0.204258 -6.73647 -0.0210952 +276 2 2.75019 0.556646 8.71194 -17.5671 6.50862 13.0872 +277 1 7.32229 17.553 4.46711 -1.8346 22.7033 -6.51397 +278 2 7.49747 18.5341 4.60164 1.92735 -36.6431 -12.1684 +279 2 7.43093 17.3591 3.50845 0.44318 8.65947 16.4016 +280 1 9.23372 17.1692 12.2368 -1.40541 18.7929 10.7586 +281 2 9.17923 16.5713 11.4947 6.54031 -16.824 -6.24154 +282 2 10.1445 17.1937 12.5849 -6.50468 -4.83213 -2.69749 +283 1 13.3883 13.1392 7.89062 -8.44361 -29.718 12.0449 +284 2 13.2983 12.3346 8.48336 5.26587 25.8846 -16.8323 +285 2 14.1176 13.673 8.22732 -1.02664 3.48474 5.19869 +286 1 14.8313 2.83639 15.4549 13.5448 -0.0778016 6.35676 +287 2 14.1767 2.18003 15.2177 -4.87233 -8.03631 -4.89691 +288 2 15.4971 2.82305 14.7488 -5.52573 3.83225 -1.21536 +289 1 9.88985 15.6498 16.9162 -1.5178 12.6863 -12.8881 +290 2 10.4068 14.8878 16.6522 -4.3383 -15.6303 0.424585 +291 2 9.57752 15.4658 17.7984 -6.29913 -5.39682 13.2163 +292 1 11.1832 8.45041 16.604 0.69795 7.62392 -5.91094 +293 2 10.4558 7.91494 16.2714 -2.08228 -2.22425 -3.83894 +294 2 11.7364 7.86183 17.1086 3.16052 -9.92137 8.33691 +295 1 3.98058 18.2281 16.8796 4.69725 -6.17709 8.80305 +296 2 4.47544 17.5796 17.4031 -3.04366 -6.21568 -3.2578 +297 2 4.2975 0.415113 17.2284 -3.71051 8.24157 -1.82763 +298 1 2.31186 4.29334 8.90298 15.9673 -19.5394 32.2139 +299 2 3.25638 4.01729 8.88792 -18.4415 10.5974 -6.3491 +300 2 2.00846 3.99585 9.80326 5.50039 13.6474 -24.2252 +301 1 9.93626 10.4071 9.85717 -7.16433 6.26663 -15.7674 +302 2 9.36967 11.1624 9.60099 8.89086 -7.49456 6.1891 +303 2 10.0442 10.3828 10.8072 -0.648607 3.91668 13.0823 +304 1 9.8312 0.910661 10.8223 11.6198 7.73817 -5.63486 +305 2 9.46664 0.0599513 11.0613 -12.5627 -8.03565 7.40448 +306 2 9.23233 1.33675 10.1908 -3.5905 -1.89286 -1.84539 +307 1 9.13587 15.2239 10.1542 8.27875 -9.17261 13.8125 +308 2 8.75897 15.8188 9.50902 -6.94043 7.83547 -6.48358 +309 2 8.46187 14.5466 10.3059 -2.40816 2.69742 -4.7236 +310 1 0.685213 9.67274 10.114 -7.63752 22.5158 18.5003 +311 2 0.719625 10.5209 10.6443 4.69174 -21.4783 -21.4849 +312 2 1.56632 9.47392 9.79675 4.15873 2.44002 -0.184199 +313 1 17.1428 4.74332 7.9842 -7.49261 0.0436566 15.7002 +314 2 16.4923 5.43036 8.24486 9.33931 -9.59151 -5.74994 +315 2 17.1543 4.09081 8.70481 -1.62938 8.73821 -5.69634 +316 1 14.873 14.5838 0.184633 -12.5055 -0.863041 8.47648 +317 2 15.4452 15.0773 0.785336 2.49238 5.2379 -3.7088 +318 2 14.1221 14.3325 0.749692 6.56524 -1.80757 -8.31994 +319 1 3.93739 11.0893 9.63941 -1.02455 -14.3236 -20.6383 +320 2 3.83455 11.1931 10.5803 -4.40039 8.60569 15.1914 +321 2 3.22961 11.5882 9.19534 2.92088 3.20496 1.27781 +322 1 11.4787 10.7372 1.42758 24.3197 -0.772389 9.7934 +323 2 11.803 11.5915 1.09275 -4.97826 -3.71445 3.9898 +324 2 10.5984 10.6629 1.1011 -26.1902 -1.18673 -8.43185 +325 1 13.1873 7.21634 12.6041 -15.1781 -16.7535 7.59792 +326 2 14.1321 7.04558 12.6338 7.66113 -4.04391 -1.22332 +327 2 12.7625 6.33802 12.7657 6.99529 16.5731 -3.03327 +328 1 9.70202 2.01155 0.798053 14.7354 3.6785 18.4689 +329 2 8.80874 1.78739 0.563168 -12.7542 -2.84597 -8.5823 +330 2 10.1462 2.35336 0.0231027 2.1886 1.53799 -6.67264 +331 1 10.5601 13.4177 4.61479 15.5689 5.45852 21.4774 +332 2 11.4398 12.9929 4.68798 -8.71776 0.745444 -2.53542 +333 2 10.4627 13.8549 5.48714 -1.1208 -2.16649 -13.1077 +334 1 14.6135 1.64587 10.9888 -15.9483 2.47769 1.03658 +335 2 15.3653 1.14828 10.6398 3.3395 9.35485 -7.37665 +336 2 14.6055 2.55489 10.6162 9.33106 -12.1869 7.67578 +337 1 14.4205 12.072 11.5247 -14.0438 -11.3661 -21.2086 +338 2 15.2325 12.1783 11.0185 5.83651 11.9615 0.736203 +339 2 13.7775 11.7491 10.8405 12.2041 8.47933 23.407 +340 1 8.16075 5.17074 9.91542 -32.2508 22.4833 15.2463 +341 2 7.26447 5.43351 10.2769 29.6925 -9.34554 -9.10024 +342 2 8.08912 4.23235 9.75273 2.68018 -15.2376 -3.85437 +343 1 1.73754 17.0197 18.4251 17.7604 24.8388 -20.6387 +344 2 2.31535 17.5448 17.7835 -20.2636 -19.608 22.2942 +345 2 1.91865 16.0976 18.2314 3.71033 -9.13614 -1.37747 +346 1 1.38218 17.4352 15.3141 25.6123 -1.10879 -8.05345 +347 2 1.40837 18.2867 15.7687 -7.1514 0.273564 3.63966 +348 2 0.483975 17.1212 15.2601 -14.2857 -2.70278 3.05549 +349 1 3.46713 5.71669 6.03858 -5.21329 -0.208659 9.269 +350 2 3.09179 6.35885 6.66621 -4.29108 -6.04245 -5.71481 +351 2 3.94628 6.22951 5.39233 13.1871 8.33197 -8.25473 +352 1 12.7108 9.52885 14.2713 4.43437 -19.6411 -8.16456 +353 2 13.1132 8.73466 13.871 -3.04318 14.9787 -8.97539 +354 2 12.4252 9.15135 15.1011 -11.0135 5.38653 13.5706 +355 1 4.12803 15.1962 7.19495 12.4066 -8.66704 -3.75127 +356 2 3.59847 15.8823 6.77325 5.03517 9.17322 -2.57748 +357 2 5.08076 15.3227 6.96437 -18.0652 5.77836 0.725546 +358 1 0.842345 8.89099 15.1297 2.31502 -25.1166 0.479797 +359 2 0.506769 9.78853 15.0967 4.66165 8.13805 -4.97691 +360 2 1.56169 8.8202 14.4757 -4.5077 5.49756 1.76436 +361 1 12.9722 8.22706 10.1223 30.4908 -35.0116 2.62512 +362 2 13.7358 7.69898 9.75664 -18.6412 19.8455 -0.140907 +363 2 12.9154 7.83668 11.013 -6.3959 11.2287 -1.2259 +364 1 15.209 8.0796 3.38747 1.18456 -35.8933 6.76248 +365 2 14.5518 7.57266 2.91157 -10.3511 16.9608 -18.4151 +366 2 15.3784 7.42989 4.0872 14.9983 19.582 11.3682 +367 1 17.1108 6.70081 18.626 -14.4882 23.5427 -0.564853 +368 2 16.573 5.93167 0.182006 3.19594 -3.93797 2.70551 +369 2 16.4292 7.40436 18.4932 17.3888 -11.7094 -2.73385 +370 1 8.93374 7.05508 7.97597 -34.6157 -22.4872 9.48373 +371 2 9.83531 7.32727 7.97774 29.5921 7.62374 2.22252 +372 2 8.80811 6.41093 8.72029 6.54491 10.6746 -16.3243 +373 1 12.5312 0.423333 1.1911 6.44852 -9.8202 9.01884 +374 2 13.2753 0.834119 1.64897 1.63592 5.99122 -1.78887 +375 2 12.9315 0.0607692 0.396252 -6.77848 2.89528 -3.69601 +376 1 5.75537 14.98 14.4363 12.3645 2.0371 -4.21343 +377 2 4.82148 15.0687 14.6213 -16.3449 4.01416 5.01671 +378 2 6.0882 15.8478 14.162 -3.83146 3.10822 0.706071 +379 1 3.69037 6.49544 1.72037 -3.07239 6.81288 -7.41536 +380 2 3.43088 7.36249 1.36332 1.27628 -12.1507 -2.18765 +381 2 3.67848 6.67228 2.6574 4.23334 -3.71069 10.2966 +382 1 3.82256 11.2843 12.3046 -0.864415 -4.77059 0.0245619 +383 2 4.71622 11.5939 12.5181 -0.579536 5.4381 2.57712 +384 2 3.18979 11.9063 12.6819 -0.230908 7.2683 5.57723 +385 1 5.33149 3.8717 15.6726 -21.611 69.2317 6.1195 +386 2 6.02506 3.28248 15.4947 35.9646 -33.3333 -4.61122 +387 2 5.75271 4.79171 15.6869 -18.1046 -35.0984 -1.75377 +388 1 13.9893 10.0773 4.7789 22.4286 4.91544 -48.853 +389 2 14.2819 9.66907 5.58109 5.23319 -9.97863 19.9681 +390 2 14.5573 9.69868 4.0468 -17.0356 6.64649 24.2901 +391 1 7.62039 17.28 9.03644 -1.79817 -13.3385 2.54351 +392 2 6.82618 17.452 9.57294 2.68689 7.94648 -2.92213 +393 2 7.87136 18.0666 8.53956 -0.560867 8.99315 -4.02364 +394 1 4.58082 14.4709 3.89205 3.13293 1.46958 -13.0867 +395 2 4.66344 15.3386 4.31009 -0.0981131 -0.860678 2.59791 +396 2 4.56838 13.761 4.54421 -0.137719 -0.424919 8.72805 +397 1 14.11 7.4138 15.8858 20.156 9.8447 -1.08692 +398 2 14.9007 7.50898 15.3123 -12.2349 -4.78906 9.9244 +399 2 14.35 7.89712 16.7003 -4.15301 -9.39138 -6.29924 +400 1 2.88871 18.3931 1.90601 -10.0733 25.2579 5.70796 +401 2 2.56074 17.6209 1.45485 -4.97176 -8.65563 -11.6917 +402 2 2.08224 0.29716 2.10455 27.8478 -15.7521 2.2348 +403 1 8.03506 1.57584 4.43091 11.32 6.26446 5.75526 +404 2 7.34029 2.01323 3.92479 3.96785 0.109851 -4.32136 +405 2 8.88243 1.87946 4.04557 -12.5027 -7.48646 4.71123 +406 1 2.59748 14.2159 17.7933 -41.9258 1.66076 -8.0641 +407 2 1.85609 13.5734 17.9588 19.2075 16.8599 2.55802 +408 2 3.39352 13.7425 17.9784 23.6145 -16.2032 6.42715 +409 1 1.02442 1.99672 13.9281 17.4639 2.95853 -13.5386 +410 2 1.00308 1.87917 14.8709 4.63864 -6.80727 18.6653 +411 2 18.7659 2.1043 13.6716 -21.6962 3.88026 -3.66909 +412 1 4.27686 0.20187 13.9044 10.5162 4.04171 -16.044 +413 2 5.10447 18.3372 13.9403 -4.05013 6.4475 2.1433 +414 2 3.72354 18.5099 14.5979 -6.57077 -5.71295 14.511 +415 1 7.38305 1.01959 18.4815 -37.4449 7.12948 8.58409 +416 2 7.61008 0.74545 17.6036 5.58611 -6.30497 -21.5445 +417 2 6.41018 1.26146 18.4662 31.347 -10.6343 7.25927 +418 1 15.7518 18.4403 13.8831 -5.31168 6.41878 -7.08883 +419 2 14.7988 18.525 13.6912 13.3949 -2.54728 9.28792 +420 2 15.9153 18.5927 14.8217 -8.96218 -2.42265 4.9219 +421 1 10.3004 4.59906 16.2125 -26.9192 -42.5531 9.44494 +422 2 11.2318 4.75068 16.1287 26.1471 2.80018 1.93501 +423 2 10.2211 3.60629 16.3773 -0.864587 37.9812 -10.9337 +424 1 15.8848 17.7109 4.47524 -26.0192 -17.7161 -6.69824 +425 2 16.416 18.4558 4.72522 12.9982 18.1701 2.23702 +426 2 14.9575 17.9834 4.62838 14.848 -2.41832 2.25768 +427 1 6.86545 17.6577 14.0262 -6.12412 -8.41921 6.45462 +428 2 7.47866 17.6693 14.7646 2.09746 6.93436 13.8689 +429 2 7.44902 17.4838 13.2997 11.4214 -0.145135 -19.8537 +430 1 13.1703 6.41318 6.52816 -11.7529 -0.316938 -15.1514 +431 2 13.9829 6.90375 6.37155 7.88734 -3.14145 2.99861 +432 2 12.7537 6.33512 5.64174 6.34445 -4.78434 12.9923 +433 1 7.85335 2.30114 9.49646 -14.1039 1.33546 -28.6309 +434 2 7.23443 2.06415 10.1901 -3.07143 2.26257 12.1486 +435 2 7.33833 2.15664 8.66054 15.7097 0.546065 18.7565 +436 1 15.1664 14.7315 13.8676 -13.4222 3.7476 -0.777794 +437 2 14.8716 15.1233 14.7167 4.70885 -6.20173 -11.3706 +438 2 14.4912 14.9291 13.1959 7.90291 2.0321 9.20294 +439 1 9.36434 8.4507 3.85153 -5.45323 -8.44175 -9.3174 +440 2 10.195 8.80526 4.18009 6.07261 4.07641 1.89943 +441 2 9.48655 7.50041 3.73575 1.17631 -1.18483 4.07146 +442 1 17.585 13.5529 16.4533 28.0827 9.29223 -15.0932 +443 2 16.6463 13.3857 16.5308 -13.0105 5.34146 -4.98563 +444 2 17.7372 14.3421 15.8749 -12.9185 -11.1551 11.5131 +445 1 5.00344 10.4544 2.83444 15.3623 2.39709 8.30796 +446 2 5.84337 10.0047 3.04968 -12.8086 4.14038 -0.288119 +447 2 4.84487 11.029 3.60723 -3.54173 -2.25206 -8.41364 +448 1 3.64071 8.37653 9.83285 -3.63557 -2.42467 19.3481 +449 2 3.86873 9.30617 9.70655 -0.364806 7.27712 -2.43853 +450 2 3.42279 8.30417 10.789 5.82381 -0.771913 -15.5307 +451 1 16.012 6.92262 5.85834 3.10414 -0.205141 -1.95775 +452 2 16.7064 7.38617 6.35888 -2.44937 -6.94247 -7.87698 +453 2 16.3342 6.01666 5.66219 -6.01431 14.0457 5.91674 +454 1 15.3573 7.28861 8.91428 -7.73552 23.9623 -29.5509 +455 2 15.9286 7.60908 9.59449 17.6585 1.69923 20.6432 +456 2 15.3281 8.05346 8.27817 -7.4668 -29.0722 12.6462 +457 1 6.23444 12.7891 12.7562 -16.1216 7.07791 -6.67583 +458 2 7.04381 12.3675 13.028 12.7717 -9.63916 7.37694 +459 2 6.08648 13.5082 13.3891 2.20208 -1.21591 -2.77254 +460 1 12.1275 4.60499 13.1618 30.5736 27.4894 8.79026 +461 2 12.1815 4.60813 14.1323 1.45244 -2.14521 -6.91324 +462 2 11.4269 4.052 12.8891 -30.6572 -22.7655 -2.33684 +463 1 11.4418 8.05897 7.8749 4.39649 -6.11408 4.26725 +464 2 12.0054 7.38105 7.40707 -4.89778 19.9996 19.2901 +465 2 11.7913 8.23063 8.79017 -1.61454 -12.0828 -25.9053 +466 1 16.8934 10.7552 7.64898 5.958 -15.487 6.46706 +467 2 17.5218 10.034 7.45777 0.434714 4.65833 3.39608 +468 2 16.8005 11.223 6.82193 -0.787623 15.1873 -12.5781 +469 1 5.19162 18.0101 10.6182 -11.7475 -9.51575 -5.50364 +470 2 4.6689 17.2843 11.0141 12.267 13.7571 -4.22389 +471 2 4.61649 18.3258 9.88348 13.0529 -7.1725 20.3587 +472 1 7.61953 17.4141 1.49962 -5.28373 3.7131 11.8258 +473 2 8.17503 16.7132 1.19553 7.57367 -21.9054 -5.9523 +474 2 7.57614 18.0024 0.755384 -3.403 20.0604 -6.05803 +475 1 1.93154 12.9424 13.6297 4.26026 1.62766 0.165619 +476 2 1.31807 12.4855 14.2164 3.08324 -4.19991 0.575461 +477 2 2.34989 13.6289 14.1741 -4.48691 2.36366 -2.57882 +478 1 9.34851 6.7636 14.8211 -2.90069 2.43692 -15.7898 +479 2 9.659 5.88476 15.1078 3.08688 5.56829 -7.87962 +480 2 9.50722 6.89182 13.8456 0.484936 -6.74561 22.7152 +481 1 15.2631 4.37275 10.7209 -0.391742 -1.67154 5.71992 +482 2 16.1506 4.03655 10.897 1.37527 -0.677682 -8.66997 +483 2 15.1154 4.97006 11.4686 -2.24536 -2.27818 -6.11794 +484 1 11.4934 6.22632 -0.0241442 -6.06296 -11.7718 -8.66306 +485 2 11.6483 5.30933 -0.309107 4.27028 6.28431 2.83608 +486 2 10.5284 6.3165 18.5406 6.28072 6.83613 2.73886 +487 1 18.4725 11.4275 14.8977 -1.36673 1.10287 -33.3787 +488 2 18.0559 11.937 14.1605 1.63397 -11.827 9.6186 +489 2 18.3384 12.0011 15.6307 -5.5196 20.2825 24.8766 +490 1 7.17852 9.29091 7.31266 -12.1778 -5.70725 -5.55247 +491 2 6.76293 8.42612 7.50122 5.49043 12.248 4.67896 +492 2 8.1168 9.11866 7.26453 10.5183 -1.31775 0.108346 +493 1 18.3399 15.3762 12.1294 6.77425 7.85663 0.444206 +494 2 0.624383 15.5788 11.9067 -6.5428 -1.83873 1.38378 +495 2 17.7957 15.9125 11.5264 -1.63248 -5.99386 0.103645 +496 1 16.5386 4.34911 5.2503 -38.2238 -21.0357 51.9327 +497 2 16.6701 3.96728 6.16388 -6.69454 12.6485 -26.055 +498 2 17.3775 4.32019 4.85382 41.1543 5.3392 -22.1831 +499 1 17.7341 3.08223 10.7755 -2.39486 19.3144 10.8573 +500 2 18.6554 3.32717 10.9901 -9.67157 -6.39923 -2.68969 +501 2 17.7406 2.18791 10.4534 3.10102 -17.6187 -9.33289 +502 1 12.3347 18.6584 10.1394 22.1152 -18.6094 -11.1242 +503 2 11.4269 0.285024 10.28 -5.50333 15.1479 5.74269 +504 2 12.9381 0.769801 10.2484 -7.53185 0.18177 2.36971 +505 1 10.4414 9.72052 12.5804 5.49259 18.5488 2.65475 +506 2 11.2372 9.86145 13.1232 -3.33328 -5.81976 -2.33485 +507 2 10.4983 8.8205 12.2639 -0.9125 -13.8337 3.2089 +508 1 0.576047 2.60181 7.2501 -1.65995 13.3288 -12.3458 +509 2 0.268028 3.48996 7.49944 2.28387 -7.91724 -1.96879 +510 2 1.05133 2.26453 8.01425 -2.57801 -1.32252 3.73717 +511 1 0.35756 15.2681 6.96461 -6.18578 -18.242 -64.2832 +512 2 0.656709 14.9904 7.8095 9.46814 -3.47663 35.1726 +513 2 0.533918 14.474 6.37104 -3.56161 26.9089 25.8891 +514 1 17.0554 6.8805 14.912 24.4713 -1.83906 11.5387 +515 2 17.8121 7.50971 14.9246 -13.4777 -6.95308 -2.51376 +516 2 17.3666 6.12061 15.452 -8.01529 8.59931 -8.57008 +517 1 9.11821 12.4896 7.9597 -39.3936 14.7629 -4.46817 +518 2 9.45619 11.6923 7.5591 7.68398 -14.1787 -12.8233 +519 2 8.20522 12.6235 7.56541 34.2702 -5.52337 13.9854 +520 1 1.14934 1.62531 2.7512 -10.6975 -16.4856 11.3042 +521 2 0.557887 1.95566 2.07466 1.95024 15.5996 -8.59751 +522 2 1.5216 2.35039 3.25303 6.14281 9.13632 1.51194 +523 1 4.18801 15.1235 9.83797 -4.3571 13.9944 -8.49019 +524 2 4.15169 15.4364 8.91421 -7.63033 -5.74015 13.5827 +525 2 5.04261 14.6826 9.83518 3.69587 -3.91806 9.7151 +526 1 7.38616 2.29059 14.8987 -4.38475 3.80451 -15.2317 +527 2 7.23636 1.51405 14.3418 -1.55041 0.530275 6.25745 +528 2 7.45512 3.02747 14.2682 8.09838 -6.66607 2.4433 +529 1 18.2954 14.5248 2.13868 21.7335 16.5649 1.154 +530 2 0.530315 14.9412 2.32201 -13.6123 -15.8317 -3.76049 +531 2 17.7186 15.2797 1.96871 -6.10103 1.83177 1.59348 +532 1 10.0818 2.68123 12.8993 0.213282 -13.011 -16.4533 +533 2 9.9804 2.00538 12.1749 2.58274 17.6757 17.7308 +534 2 9.30115 3.24961 12.8455 -1.77409 -0.0668197 -1.90377 +535 1 2.92042 8.79199 13.1038 3.60331 12.5418 -6.85933 +536 2 3.19747 9.71233 12.8787 -2.51528 -19.5049 2.84802 +537 2 3.74925 8.3139 13.2755 -6.12566 -1.47569 1.35688 +538 1 3.2826 8.6043 3.78787 -1.06696 -30.5523 53.3514 +539 2 3.6648 9.24286 3.23576 21.5217 31.7748 -30.2126 +540 2 3.73659 8.75462 4.6619 -18.3855 -4.45548 -24.3241 +541 1 5.99503 7.23605 8.68049 -5.70462 -6.01689 -7.52618 +542 2 5.88732 6.32464 8.37432 -5.09887 -1.13221 5.21957 +543 2 5.15444 7.50455 9.08765 4.58913 -3.02319 1.70333 +544 1 14.8694 1.67632 1.824 4.95495 -3.07302 -21.4612 +545 2 14.923 2.54765 2.20438 -6.9063 6.82762 18.8127 +546 2 15.1986 1.83723 0.92353 -1.55356 -7.84532 7.79991 +547 1 8.71318 14.9586 0.633889 5.3189 4.72704 12.5337 +548 2 9.41548 15.0137 1.3229 -12.9747 -8.59069 -7.21106 +549 2 7.9574 14.4505 1.00218 9.17218 5.81258 0.251254 +550 1 15.3522 1.50057 7.22863 -1.61242 -14.2743 -3.26221 +551 2 14.7819 0.961058 6.63945 7.54361 11.5891 10.8038 +552 2 14.804 2.18796 7.6304 -1.95204 4.928 -5.75504 +553 1 4.88832 12.8638 18.4669 14.1773 6.076 10.5021 +554 2 5.16486 12.9634 0.754115 -2.57074 -3.9589 -10.7447 +555 2 5.64539 13.2163 17.9734 -6.87045 1.01425 -0.872896 +556 1 15.3658 8.71105 18.1022 0.313753 1.99863 -15.4271 +557 2 15.6825 9.25538 17.3367 -2.33671 -6.91366 23.9636 +558 2 15.2177 9.29821 0.21527 -1.89476 6.92048 -0.597105 +559 1 12.0025 3.14868 18.2874 -4.08601 9.85731 -2.22671 +560 2 12.1144 3.11564 0.603374 4.33643 -8.86024 -4.9595 +561 2 12.4653 2.40747 17.863 0.0624807 -1.52737 7.22507 +562 1 13.2135 12.7035 5.12884 9.73413 0.384952 2.90661 +563 2 13.7 11.8654 5.00774 -9.98906 4.00813 0.0328844 +564 2 13.4141 12.9701 6.04548 -3.79483 -4.91087 -6.97232 +565 1 6.18903 7.09371 0.234798 3.60985 -26.8596 -14.0682 +566 2 6.2071 8.04594 18.8061 -7.0012 19.4313 6.00448 +567 2 5.26363 6.79856 0.279731 4.49735 8.94005 5.55961 +568 1 17.7003 15.89 14.853 -18.1963 11.2058 -20.3772 +569 2 16.8346 16.3247 14.8039 6.19322 -4.54728 12.6057 +570 2 17.8435 15.7325 13.9057 13.4875 -6.37623 4.18836 +571 1 13.0834 0.870867 16.8965 -0.161813 1.3846 -1.86612 +572 2 14.0072 0.582211 16.892 1.10768 1.72224 0.871652 +573 2 12.5754 18.726 16.653 1.71204 -0.315799 1.62538 +574 1 10.8945 14.507 7.48359 31.9827 12.7774 -14.5262 +575 2 10.2535 13.8684 7.76101 -18.1255 -14.8352 9.6937 +576 2 11.748 14.0397 7.49435 -7.74827 -1.48019 1.36014 +577 1 17.7521 8.40099 2.11802 -4.68381 10.101 13.2464 +578 2 16.8759 8.32923 2.50971 -7.38706 6.94009 5.95596 +579 2 17.7532 7.67887 1.5098 2.25561 -17.6604 -22.6471 +580 1 12.5231 7.84865 2.0094 -2.30264 15.9804 1.37474 +581 2 12.1379 8.74758 1.97393 9.3167 -10.0751 -1.70323 +582 2 12.325 7.4571 1.14918 -4.66948 -5.90928 2.89896 +583 1 11.972 14.5025 10.3451 -2.96888 12.9379 -2.77484 +584 2 12.1874 14.7132 9.42348 -1.74009 -6.18971 10.5862 +585 2 11.0277 14.706 10.4449 2.87573 -2.36207 -4.30421 +586 1 6.71227 6.84952 15.5806 25.6498 -3.78319 22.6581 +587 2 7.68828 6.90632 15.3859 -23.8939 0.442938 5.1849 +588 2 6.62279 7.02219 16.5478 -0.830995 -1.23763 -22.0679 +589 1 7.92027 4.40739 13.1357 7.88731 17.7005 28.4833 +590 2 7.20639 4.70613 12.563 -5.96959 3.19417 -4.54574 +591 2 8.05118 5.13552 13.7952 -2.84521 -16.8776 -20.7331 +592 1 13.2899 12.2294 14.3537 -3.3223 6.18653 6.3482 +593 2 12.9901 11.3268 14.1873 4.87208 -4.78833 3.90165 +594 2 13.6879 12.5058 13.5223 1.91273 0.0234059 -4.06458 +595 1 14.5389 9.51264 7.32918 -7.01434 -27.1539 -11.6023 +596 2 15.2763 10.0624 7.53312 20.4851 16.6908 8.43718 +597 2 13.8132 9.80854 7.861 -14.3264 8.19434 11.2695 +598 1 12.68 16.8773 3.29092 2.11558 25.6431 -8.94229 +599 2 12.7733 17.3894 4.13219 -1.2803 -9.72294 -18.9636 +600 2 12.6793 17.5234 2.53176 -0.650571 -10.0569 23.6182 +601 1 0.970813 7.05439 17.3478 19.6691 8.71735 -9.44801 +602 2 0.0997442 7.2771 17.6294 -27.888 -7.65058 15.2547 +603 2 1.07493 7.61203 16.5711 5.30897 3.90939 -5.98442 +604 1 13.0218 4.86702 15.7977 -14.5255 -22.5737 -0.430567 +605 2 13.6652 4.12206 15.7771 -2.73243 23.3382 0.768668 +606 2 13.4898 5.70142 15.8866 10.098 7.61534 -0.732483 +607 1 2.35004 3.40025 5.07686 -12.6408 -17.529 -7.45963 +608 2 1.84891 3.15034 5.87751 4.27568 5.0167 -3.29201 +609 2 2.74325 4.26374 5.21682 1.23402 6.29722 12.7184 +610 1 8.14417 10.9001 13.7499 9.28616 -30.1931 45.6744 +611 2 7.9506 10.3552 14.611 8.46781 36.9232 -44.8577 +612 2 9.00813 10.5574 13.4404 -10.6035 2.99953 -2.14266 +613 1 13.0821 1.49083 13.2989 5.3891 9.28887 -24.1834 +614 2 13.7872 1.3627 12.5959 -25.8284 12.5052 17.3021 +615 2 12.4896 2.22352 12.9857 19.0093 -19.6589 8.86348 +616 1 6.62484 13.6674 2.02561 -2.30013 1.61314 -5.1998 +617 2 5.94206 14.1599 2.51404 7.05284 -6.38204 5.2583 +618 2 7.12137 13.1184 2.65568 -4.11309 1.61678 2.96157 +619 1 15.7857 6.33001 12.4874 9.47505 -1.37582 18.5865 +620 2 16.2809 6.76838 11.7933 3.97273 7.7159 -2.96061 +621 2 16.3586 6.41799 13.2831 -12.689 -0.09302 -8.30077 +622 1 16.7471 0.613682 9.52771 11.5447 -14.6629 17.7173 +623 2 16.7567 18.2848 9.57147 -3.7535 4.88819 4.87116 +624 2 16.43 0.840462 8.66213 -13.2327 5.78697 -22.1845 +625 1 6.19152 11.681 8.24955 3.80355 -8.99636 -2.81467 +626 2 5.36879 11.4903 8.73023 3.19436 -10.2741 -4.0588 +627 2 6.55865 10.8405 7.8788 -10.8203 9.76695 14.653 +628 1 2.78766 8.56788 0.409413 -52.7319 2.11899 -11.855 +629 2 2.08185 8.03903 18.552 32.3713 20.2249 14.5342 +630 2 2.26775 9.27739 0.866586 13.6595 -12.5773 -9.56289 +631 1 10.1003 10.2385 6.61376 -10.8952 5.58665 6.62413 +632 2 10.4921 9.47201 7.04387 8.70092 -2.05853 1.95229 +633 2 10.597 10.3787 5.79806 -1.31095 -2.00825 -0.431677 +634 1 6.84539 15.7603 6.76774 -1.32488 -8.5888 0.285168 +635 2 7.15445 16.2386 7.5582 -1.07119 -0.859265 -6.52036 +636 2 7.16186 16.249 5.99512 -0.908646 8.8198 -0.167177 +637 1 6.64088 12.8596 5.99362 6.27305 7.11444 -12.0385 +638 2 6.74407 13.8044 6.07603 1.27228 12.7365 2.69296 +639 2 6.25078 12.5941 6.82297 -5.96354 -7.18103 4.5408 +640 1 16.6867 12.5722 9.84379 -3.64815 -5.06409 7.40683 +641 2 16.7505 11.8965 9.15556 3.82735 1.49832 -4.74998 +642 2 16.8024 13.43 9.4304 0.212763 1.2752 -2.86494 +643 1 6.31521 2.74143 2.73106 -6.87016 -8.03266 -4.4066 +644 2 6.55003 3.64872 2.52358 -0.655364 10.9132 -0.0341781 +645 2 5.98199 2.35933 1.9027 -1.39596 -0.0669143 5.2552 +646 1 10.642 2.89265 3.25205 -8.44131 -1.48195 -5.66324 +647 2 10.1183 3.68518 3.4139 4.92295 3.00907 1.37692 +648 2 10.2968 2.53281 2.41595 2.77965 2.00448 3.56419 diff --git a/examples/amoeba/dump.water_box.amoeba.32 b/examples/amoeba/dump.water_box.amoeba.32 new file mode 100644 index 0000000000..9019401850 --- /dev/null +++ b/examples/amoeba/dump.water_box.amoeba.32 @@ -0,0 +1,7227 @@ +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.67966 7.08769 17.9461 -18.0057 -16.954 4.82612 +2 2 7.80945 6.75579 18.2607 19.8034 12.4721 -7.17463 +3 2 8.72223 6.81424 17.0254 7.13784 0.0282027 3.08606 +4 1 18.5257 8.24445 6.83762 8.52147 14.2257 60.5703 +5 2 0.216892 7.89544 6.05003 12.0964 -15.6711 -53.3384 +6 2 0.444268 7.82601 7.5302 -13.3675 6.47926 -9.3119 +7 1 8.37906 18.5504 6.81463 24.6094 6.61103 -1.11969 +8 2 9.34042 0.098069 6.73406 -18.7879 -2.64022 0.747908 +9 2 7.93962 0.573676 6.26984 -2.09268 1.16699 2.67386 +10 1 6.58995 1.84432 11.7198 46.7475 -13.739 -10.5489 +11 2 5.88543 2.40231 11.9251 -37.1346 27.545 16.57 +12 2 6.18153 1.06275 11.3693 -7.36455 -17.4045 -5.52161 +13 1 7.1466 5.75358 2.33152 -53.3657 41.599 -1.38826 +14 2 6.36812 6.12603 2.86268 38.0857 -22.9036 -2.95785 +15 2 7.02502 6.29465 1.5182 16.1101 -20.4591 11.2904 +16 1 16.2164 10.1388 16.1382 -32.9296 19.8915 17.3579 +17 2 16.9509 10.2747 15.5847 32.6569 -1.09677 -20.2087 +18 2 15.8498 11.0405 16.2399 2.59134 -12.8635 2.30838 +19 1 10.6046 15.0374 2.30369 -9.45108 -28.933 -9.95229 +20 2 10.5292 14.3949 3.01849 1.67759 -0.529274 5.48943 +21 2 11.0236 15.78 2.70962 13.2591 21.3673 6.11781 +22 1 17.1624 8.24409 10.3708 10.41 5.9387 11.3227 +23 2 16.5528 8.68798 10.966 -4.81374 9.55532 3.583 +24 2 17.9421 8.82333 10.3208 -3.63548 -8.99367 -3.64514 +25 1 14.901 15.8652 16.3167 21.2892 -10.1645 16.79 +26 2 14.0225 16.1982 16.2525 -30.7371 12.6366 -7.00126 +27 2 14.9141 15.482 17.2099 1.64171 -7.21798 -3.7798 +28 1 12.1752 13.3771 0.408263 -10.449 7.39269 11.8256 +29 2 12.0579 13.8465 18.23 5.34035 -4.48355 -17.1718 +30 2 11.6217 13.8904 1.00796 2.45905 -0.157672 9.39156 +31 1 9.27358 5.34243 4.05546 -29.354 32.8373 13.3322 +32 2 8.64594 5.4665 4.83764 23.9402 -17.6274 -26.2044 +33 2 8.74177 5.68615 3.30282 4.39732 -15.4932 8.77495 +34 1 1.83016 4.27673 11.6495 -22.4867 33.9085 -11.1027 +35 2 1.70328 5.22377 11.9391 5.26663 -24.2909 -6.35354 +36 2 2.40811 3.85345 12.2597 16.6835 -12.3735 20.3319 +37 1 1.96438 6.83299 8.3731 -11.8866 6.09586 -26.8326 +38 2 2.49614 7.21578 9.0563 11.4719 0.0715494 18.6532 +39 2 1.81128 5.90585 8.57354 7.57659 -6.58781 5.32172 +40 1 5.40557 4.38899 7.93274 -5.84675 9.40812 -2.24834 +41 2 5.53738 3.43895 7.78131 -7.95286 9.95376 -0.129754 +42 2 4.75516 4.73491 7.29062 11.2407 -18.5615 7.61563 +43 1 3.23 2.92842 17.5524 1.14755 15.2746 17.0601 +44 2 3.93109 3.19827 16.9402 0.871842 10.3641 0.782189 +45 2 3.00444 3.70897 18.1497 2.9668 -26.2705 -22.3315 +46 1 7.4624 5.26283 6.13117 4.99569 4.7543 -2.87263 +47 2 8.02565 5.58849 6.88177 -21.8117 -10.641 -11.2175 +48 2 6.93508 4.45577 6.3254 15.5754 16.5621 10.3274 +49 1 9.77896 7.02384 11.9834 11.1892 -4.91774 24.9965 +50 2 10.2721 6.37256 11.5011 12.944 -11.2243 -3.64487 +51 2 9.1532 7.31587 11.3499 -25.3515 14.1302 -21.9158 +52 1 14.1167 3.54999 8.03003 -26.7224 -2.96987 -36.9282 +53 2 13.4732 4.22413 7.73132 14.0058 -9.36539 3.16858 +54 2 14.3809 3.80189 8.88487 12.5079 17.7406 36.8421 +55 1 4.82329 17.2568 4.03846 -17.1239 31.8599 -29.451 +56 2 5.49315 17.973 4.01308 -7.2715 -20.7015 10.2799 +57 2 4.18746 17.5412 3.33843 11.1391 -13.8034 10.6312 +58 1 16.4918 16.6259 10.0493 30.7319 18.7558 -40.9431 +59 2 16.1673 16.3226 10.8594 -24.9276 -14.9205 38.9888 +60 2 15.9925 16.2084 9.33562 -5.59472 -4.21747 7.16045 +61 1 1.94489 4.93323 0.49791 29.2037 9.87254 4.22328 +62 2 2.55322 5.26335 1.2053 -16.134 -9.14189 -14.6469 +63 2 2.08253 5.591 18.4408 -15.0883 -1.49688 2.64821 +64 1 11.816 13.3571 16.2711 -9.40148 3.94995 7.41554 +65 2 11.2371 12.6203 16.5671 11.2868 -0.226619 -16.3723 +66 2 12.2446 13.1893 15.4079 -8.93504 -7.51369 10.5349 +67 1 10.105 11.0651 16.9545 19.171 -30.5561 3.11717 +68 2 10.5674 10.1947 17.1295 -13.2328 27.8223 -6.21699 +69 2 9.25349 10.8067 16.5912 -4.96621 2.04172 2.74708 +70 1 11.7264 17.5421 13.4742 -3.04385 -27.7441 -11.1528 +71 2 12.2771 16.9836 12.8968 -5.80236 0.92931 5.24929 +72 2 12.1041 18.3936 13.317 3.92972 25.4072 2.69815 +73 1 6.33029 9.31911 12.2264 14.5686 -26.7823 -24.0739 +74 2 7.02603 8.96242 11.6353 -16.9594 2.64581 0.0898615 +75 2 6.81249 9.95941 12.7172 6.645 23.591 18.9185 +76 1 16.2187 12.7249 2.70186 -8.60429 -40.8729 7.98732 +77 2 17.0292 13.1566 2.50302 21.6794 20.3416 -10.6726 +78 2 15.4982 13.3357 2.61812 -11.4268 23.7847 2.88762 +79 1 0.637202 12.5625 5.84914 -31.8402 8.87564 3.58131 +80 2 0.892312 12.5507 4.90771 -4.9886 -2.92912 11.9697 +81 2 18.3039 12.804 5.85329 37.806 -5.77498 -8.15105 +82 1 5.19922 16.3781 18.5047 -8.79571 2.1563 -13.4584 +83 2 5.80284 15.8543 17.9455 2.86332 8.92403 13.1762 +84 2 5.67034 16.9636 0.462296 7.01287 -6.10758 -1.1835 +85 1 0.510145 7.62945 4.0545 45.1401 15.6351 -20.049 +86 2 18.5719 8.14656 3.45296 8.17292 -14.6601 7.70417 +87 2 1.46496 7.74082 3.66917 -48.4928 -0.554047 23.6518 +88 1 3.14672 8.89584 6.52626 -55.2927 3.32392 -1.46176 +89 2 3.50609 8.59991 7.35294 11.5609 -2.03159 9.82262 +90 2 2.14573 8.92962 6.68203 43.6989 0.357582 -10.1043 +91 1 7.30854 10.3037 16.1717 1.78466 -0.469392 13.5048 +92 2 6.56213 10.4624 15.5802 -0.177974 -0.17468 9.69093 +93 2 6.99303 10.278 17.1118 -1.93161 2.46429 -18.5659 +94 1 11.1122 1.06968 4.98939 -2.5529 -18.3754 16.0671 +95 2 11.0776 1.97142 4.64864 2.28669 -2.46607 -13.2595 +96 2 10.7048 0.433547 4.37027 3.43033 14.549 -3.59534 +97 1 4.45204 2.70061 13.2052 -5.66348 -30.5004 33.0628 +98 2 4.60333 3.05865 14.0914 -1.92534 16.2672 -14.1546 +99 2 4.38645 1.737 13.4626 -0.349226 19.9023 -23.5316 +100 1 8.42792 10.0237 1.78469 -10.3917 -19.899 15.7952 +101 2 8.3405 10.6377 2.53622 4.61332 0.207175 -2.25283 +102 2 8.49672 9.11244 2.17467 4.01989 28.7847 -10.326 +103 1 10.5335 1.75383 15.546 -34.1458 -0.453574 1.15961 +104 2 11.3977 1.82718 15.9216 24.1476 -5.37633 -0.0681618 +105 2 10.5608 1.78317 14.5837 3.50677 3.31298 -0.339701 +106 1 2.77693 12.941 7.74821 -10.4378 -0.583625 -1.53852 +107 2 3.28797 13.5733 7.23382 6.48403 3.62296 3.43855 +108 2 1.98704 12.8256 7.20013 3.29426 -8.64685 -0.0486837 +109 1 3.63517 11.6895 5.33963 -11.8109 -10.1864 -4.68879 +110 2 3.35385 11.0502 6.03137 5.66752 13.6786 -16.6554 +111 2 2.8758 11.855 4.74058 12.1084 -4.04172 11.1294 +112 1 6.88803 14.474 16.8428 -11.4129 11.5698 10.6698 +113 2 7.55973 13.8293 16.6383 5.64016 -3.74285 -2.32739 +114 2 6.60381 14.8838 16.0165 -1.10143 -9.42407 -1.70294 +115 1 14.1722 14.5374 3.41536 22.8916 -3.95473 -24.8295 +116 2 13.6514 15.2845 3.14096 -10.2906 15.0357 0.984662 +117 2 13.8512 14.2508 4.25439 -13.7068 -8.63673 17.9444 +118 1 8.28226 18.1809 16.0824 -12.751 -14.2632 -6.38017 +119 2 8.77677 17.3494 16.3071 3.86396 27.0257 -3.69586 +120 2 8.7603 0.384816 15.9919 13.8336 -15.3184 3.9152 +121 1 4.73724 1.61643 4.90111 4.42093 34.2728 -25.3552 +122 2 3.96969 2.16837 5.15263 7.5353 -10.5013 -8.47368 +123 2 5.18465 2.1484 4.15475 -16.3947 -25.6944 40.0476 +124 1 15.1457 12.8616 16.4403 -17.2871 -9.38827 44.2976 +125 2 14.6041 12.8692 17.2613 20.1997 8.40389 -10.3991 +126 2 14.49 12.6307 15.8136 -19.9308 -5.03226 -40.1466 +127 1 15.779 18.3837 16.786 46.4421 11.1965 42.4368 +128 2 16.5108 18.615 17.4688 -40.0732 -8.23978 -31.409 +129 2 15.7694 17.4186 16.7687 -10.9286 -0.13557 -0.275231 +130 1 1.1383 1.1331 16.5571 -3.78806 10.8903 6.59298 +131 2 1.96551 1.50352 16.9177 -13.4358 3.04324 -1.88802 +132 2 0.420521 1.53444 17.0916 18.9396 -8.74897 -5.5358 +133 1 18.0817 4.5907 15.863 15.5867 -18.8741 -0.0488223 +134 2 18.5818 3.91936 15.3489 -11.2031 15.1049 7.34982 +135 2 18.5602 4.7339 16.6874 -0.349245 -1.77666 -1.18458 +136 1 12.22 16.9378 16.1148 -5.50141 -11.6153 60.0453 +137 2 11.409 16.6934 16.6676 25.9686 4.83442 -31.2532 +138 2 11.9646 17.3216 15.2917 -16.184 2.10738 -25.7541 +139 1 15.8709 2.55221 17.9707 -0.937802 24.4841 -15.6355 +140 2 15.7355 3.48355 18.2574 7.57333 -26.0521 3.95198 +141 2 15.6659 2.59235 17.0072 3.66916 -5.77112 18.206 +142 1 6.70868 13.791 10.2637 2.56639 25.7323 0.00368182 +143 2 6.59347 13.548 11.1958 -0.357243 -4.92282 -5.01928 +144 2 6.58252 13.0514 9.6765 -3.72683 -17.1721 -0.802691 +145 1 10.146 18.2027 2.80372 18.7695 36.9578 -11.0057 +146 2 10.2207 0.331961 2.18345 -3.04248 -21.6078 13.7214 +147 2 9.26571 17.8868 2.67703 -19.5044 -8.44618 -8.21612 +148 1 2.97538 17.748 6.06078 -25.8303 0.797173 6.8887 +149 2 2.09399 17.6473 5.67013 0.763714 -3.05404 12.9421 +150 2 3.45883 17.8838 5.26396 31.3429 0.483929 -10.2997 +151 1 12.558 17.0134 7.97028 5.92903 -16.4499 -7.28316 +152 2 11.9572 16.2512 7.82085 0.921176 10.9238 13.6165 +153 2 12.4657 17.4524 8.83591 -10.9555 -3.32417 -4.29455 +154 1 14.8795 15.2862 8.28544 4.29768 -18.9738 42.4504 +155 2 13.9824 15.6136 8.40666 -1.92729 9.60106 -14.0248 +156 2 15.2312 15.4641 7.43118 3.9302 10.2131 -33.7787 +157 1 17.5429 18.3228 0.375372 -51.2916 -3.32975 -15.7386 +158 2 18.116 17.6308 0.128652 39.2354 -21.6017 -8.51882 +159 2 17.9698 0.288559 0.934677 25.0864 23.4945 21.3611 +160 1 0.910209 10.3712 1.41143 1.2541 -53.8465 46.4292 +161 2 0.158544 9.88347 1.87089 19.8792 18.5163 -27.3041 +162 2 0.565924 11.0969 0.944383 -23.7591 37.8535 -27.1782 +163 1 1.55407 12.175 3.31087 17.0236 24.8743 53.6813 +164 2 1.36245 11.4802 2.72234 -7.32763 -23.5838 -35.6732 +165 2 1.61623 13.0206 2.87285 0.136729 5.19924 -18.0355 +166 1 0.543127 17.2543 4.88609 31.8084 34.0538 -50.8525 +167 2 0.11032 17.9772 5.31124 -21.3387 12.8349 12.3342 +168 2 0.420366 16.4266 5.2673 -11.294 -44.4064 35.6607 +169 1 1.10053 1.01949 9.38768 20.2638 -3.47079 3.57058 +170 2 1.46081 0.575286 10.1589 5.67003 5.93636 13.5245 +171 2 0.265613 0.594128 9.34525 -28.6257 -3.15214 -10.2647 +172 1 16.8007 2.32783 13.2877 6.99662 17.0137 -29.7497 +173 2 17.0701 2.57314 12.3549 -10.9982 -8.19012 27.7721 +174 2 16.4263 1.43993 13.282 0.147057 -7.47121 1.20179 +175 1 2.45231 15.8283 12.1942 24.161 -10.1121 18.9704 +176 2 2.8623 15.5513 13.0537 -7.72007 6.59246 -26.0318 +177 2 2.91392 15.3801 11.4615 0.0476102 5.48907 2.61928 +178 1 16.435 15.531 5.9458 18.7492 36.0842 -19.2976 +179 2 17.3808 15.5177 6.20547 -11.8351 -4.55683 5.24266 +180 2 16.4147 16.2211 5.22063 -11.381 -14.928 22.2973 +181 1 5.84547 5.02056 11.8065 17.7106 -18.2202 -11.4458 +182 2 5.55799 5.91374 11.8891 -12.2572 20.16 10.1838 +183 2 5.09 4.45915 11.9819 -6.52029 -3.58907 3.63352 +184 1 15.2214 4.86555 0.731755 -13.1216 -14.4231 22.9417 +185 2 14.6776 4.45845 1.47821 22.203 16.7553 -20.5876 +186 2 14.6696 4.95834 18.5986 -12.3693 6.08689 2.65647 +187 1 16.3401 16.2933 2.11217 18.14 -13.9799 -32.9854 +188 2 16.0666 16.7695 2.87319 -13.0548 23.8975 25.5489 +189 2 16.7601 16.9279 1.50378 -12.2165 -0.858221 10.4248 +190 1 0.305885 4.87877 3.79118 -8.03527 51.7998 21.7755 +191 2 0.299338 5.85541 4.09758 -2.9952 -44.8334 -24.4202 +192 2 1.16991 4.5635 4.03062 6.79251 -10.5604 -0.715716 +193 1 2.92501 14.9782 15.0356 -0.55527 3.1583 33.427 +194 2 3.0159 14.7264 15.9987 -0.365372 -5.40078 -25.4532 +195 2 2.35392 15.7535 15.1247 4.98076 9.37108 -6.84819 +196 1 1.1115 14.5727 9.55731 53.2995 18.2393 -15.0567 +197 2 2.08491 14.4157 9.46275 -24.2978 21.5236 -5.71591 +198 2 0.897072 13.7408 9.90248 -27.8007 -35.1999 18.1171 +199 1 13.6501 16.6688 11.5433 6.47975 17.456 -8.04391 +200 2 13.4697 17.4567 10.9694 -3.73037 -22.0736 15.6897 +201 2 13.5721 15.8897 10.9842 -9.76738 -0.866763 -1.05724 +202 1 4.73098 1.47842 0.720986 0.301824 -3.12152 0.469647 +203 2 4.27169 1.98826 0.034225 -8.26683 -3.93854 8.43126 +204 2 4.11741 0.788607 1.06182 2.96071 12.6313 -1.58966 +205 1 1.42158 18.4663 11.9139 -14.1117 26.2958 -21.249 +206 2 1.21766 0.394331 12.6648 1.16138 0.455671 2.39682 +207 2 1.94844 17.765 12.2423 13.6408 -23.7742 11.0988 +208 1 11.5498 10.1018 4.11619 25.3456 17.7005 -19.3629 +209 2 11.5687 10.5955 3.24216 -3.14233 -16.3641 23.7483 +210 2 12.4899 10.1059 4.45555 -25.4417 -1.6091 -14.3563 +211 1 8.38254 12.182 3.76573 -28.852 -4.31545 3.66513 +212 2 9.25863 12.501 4.06076 -17.1001 4.9792 7.32521 +213 2 7.63736 12.4251 4.40785 39.3791 -3.23553 -14.7997 +214 1 14.3228 4.03714 3.29709 9.27375 -1.14036 13.2131 +215 2 14.8928 4.14179 4.10547 -9.51715 0.900554 -20.2647 +216 2 13.4701 4.45558 3.48891 4.64833 -1.13545 4.69814 +217 1 5.58188 1.78199 7.50513 -29.4992 -43.0538 46.7434 +218 2 5.0172 1.13958 8.12095 30.2312 35.5173 -41.7355 +219 2 5.33078 1.59122 6.59529 -0.079259 -3.9625 -11.0752 +220 1 17.9086 1.12503 4.88467 2.95857 -4.16946 -9.18468 +221 2 18.4038 1.54032 4.14207 -4.82318 -1.26447 16.1692 +222 2 17.6814 1.78344 5.55455 4.62183 1.86586 -4.7268 +223 1 6.83101 9.39303 4.49716 -16.0719 2.4093 -32.0921 +224 2 6.83675 9.57499 5.42715 5.68499 0.0447418 21.7322 +225 2 7.66807 8.99049 4.24996 11.5264 2.90932 7.40733 +226 1 2.71406 14.9654 1.962 -15.6661 -3.22344 -28.3015 +227 2 3.33343 14.7912 2.66354 12.1361 -6.91733 6.37301 +228 2 3.09502 14.6645 1.10257 -2.31521 10.6903 23.881 +229 1 17.279 12.8803 13.1283 -15.852 18.187 11.8592 +230 2 16.4044 13.2339 13.3283 -9.52452 -19.4408 0.302495 +231 2 17.6948 13.7346 13.0834 29.0619 4.95471 -11.8483 +232 1 15.0196 10.5818 1.38314 -38.2265 -36.9922 -31.977 +233 2 15.5102 11.1963 1.85791 34.2907 40.991 28.9525 +234 2 14.3351 11.0964 0.933298 3.32659 -5.3471 5.33786 +235 1 5.71789 6.95838 4.52856 0.683996 -27.8748 7.64407 +236 2 5.85266 7.87985 4.34179 3.58991 17.4746 0.820156 +237 2 6.44364 6.70841 5.13514 -10.315 -1.76088 -5.92415 +238 1 8.12142 8.26262 10.159 -0.695069 1.43108 44.445 +239 2 8.58519 8.93965 9.66877 7.60931 4.76567 -12.7632 +240 2 7.56021 7.74854 9.59836 -11.8614 -6.52029 -23.2391 +241 1 13.5311 18.2901 5.8079 -10.639 -13.2321 14.1155 +242 2 12.703 0.102298 5.56963 3.89465 4.4637 5.13268 +243 2 13.2939 17.6289 6.50758 1.00889 22.2284 -14.4481 +244 1 0.327324 2.56344 0.113251 1.70035 12.7901 -0.992224 +245 2 18.009 2.52214 18.5736 8.63965 15.9711 4.89881 +246 2 0.724331 3.48299 0.160564 -21.1536 -24.6374 0.514976 +247 1 12.6396 10.9599 9.76875 -56.8672 19.3176 -11.2335 +248 2 11.6552 10.7306 9.75031 35.1307 23.7735 -5.55284 +249 2 12.944 10.1383 10.0842 27.9729 -33.5927 10.4043 +250 1 0.789377 12.2851 11.08 11.4395 6.49483 14.2632 +251 2 18.4919 12.3017 11.2021 -18.2818 -3.30898 -6.09679 +252 2 1.09088 12.7637 11.8722 5.75277 -12.0493 -6.6955 +253 1 5.04567 7.2193 13.4912 -21.0137 -4.20407 -15.1033 +254 2 5.59899 7.84649 13.0247 8.33052 12.0635 4.31379 +255 2 5.48047 6.97898 14.3058 12.3979 0.954472 8.53674 +256 1 1.28609 6.99027 11.837 -51.8154 -68.8711 -15.2848 +257 2 0.481329 7.14037 11.2978 13.8945 0.267944 10.341 +258 2 1.71601 7.79102 11.8803 31.2664 60.1884 9.92158 +259 1 15.4442 9.46712 12.3088 17.5832 34.764 29.4487 +260 2 15.6103 10.4448 12.4444 -11.1607 -30.7672 -13.8763 +261 2 15.5582 9.10301 13.208 -6.74487 -0.409264 -16.2653 +262 1 16.6404 12.9744 5.44078 0.476019 -21.9889 6.56196 +263 2 16.2955 13.8866 5.54247 3.20084 -14.9841 -16.6056 +264 2 16.51 12.593 4.54035 -6.85686 22.0547 12.2483 +265 1 6.17495 10.0683 0.210584 -24.8048 -7.78292 -31.6597 +266 2 5.35839 10.4511 0.557392 3.36584 -0.936069 -2.46609 +267 2 6.76092 10.0813 0.943985 27.7338 0.90169 16.297 +268 1 12.3644 6.05734 4.04236 -18.3706 -38.3329 30.2118 +269 2 12.4738 6.70802 3.38308 -4.23006 32.9396 -25.2938 +270 2 11.4212 5.77124 4.03221 17.6012 8.78206 -0.800798 +271 1 0.124733 12.8266 0.203961 3.20067 -1.28022 -4.47052 +272 2 0.029974 13.5935 0.786871 -4.13202 -3.19163 0.984476 +273 2 18.185 12.9963 18.0877 7.32574 2.49628 4.77591 +274 1 3.83931 18.5785 8.61972 20.3146 -6.32916 -11.386 +275 2 3.58625 18.36 7.70531 -8.03976 -3.33875 5.01892 +276 2 3.07994 0.282626 9.06556 -19.534 7.19375 -0.404578 +277 1 7.37599 17.2741 4.45241 46.8945 31.0513 1.9622 +278 2 8.02493 17.9603 4.76808 -26.2103 -24.7083 -3.79352 +279 2 7.47725 17.3636 3.49301 -14.0292 -8.10987 6.13371 +280 1 9.20909 17.0315 12.2197 40.0448 -1.21715 18.2255 +281 2 9.48765 16.172 11.8421 -14.9023 11.2095 -3.08284 +282 2 9.99892 17.2887 12.7762 -22.6762 -6.36186 -10.9913 +283 1 13.3284 13.0292 7.94175 -54.0325 -32.963 -10.3586 +284 2 13.0533 12.253 8.47808 14.6554 7.99008 1.85075 +285 2 14.1985 13.2855 8.14946 35.8516 11.3519 14.341 +286 1 14.9871 2.94126 15.3478 14.8638 12.3357 -7.44451 +287 2 14.2243 2.52816 14.9303 4.35222 -7.49481 -2.56315 +288 2 15.7054 3.02501 14.6718 -19.1947 -5.47381 11.1555 +289 1 9.85637 15.4939 17.0026 4.34281 7.61827 -6.92944 +290 2 10.2013 14.6312 16.7411 4.19591 2.79737 -1.68983 +291 2 9.35728 15.3668 17.8085 -9.66212 -2.87408 7.84053 +292 1 11.2848 8.23994 16.5492 3.25751 34.7591 1.5155 +293 2 10.8315 7.75123 15.8747 -12.3664 -15.1549 -6.58201 +294 2 11.7506 7.62533 17.1016 5.33248 -14.8245 8.28699 +295 1 3.77097 18.1898 16.7118 4.01905 33.5947 11.0152 +296 2 4.24576 17.6768 17.3569 8.65949 -22.0954 6.28955 +297 2 3.7978 0.441972 17.1008 -4.25038 -14.6471 -12.4326 +298 1 2.20581 4.09889 8.95874 2.08991 2.93543 4.28652 +299 2 3.00197 3.55544 8.74643 -14.7124 14.9899 14.3923 +300 2 2.10364 4.24367 9.94001 10.2614 -16.6264 -23.5165 +301 1 9.9196 10.3581 9.75231 -25.3187 14.4865 -18.1673 +302 2 9.34403 11.1055 9.40387 23.5511 -18.6954 16.391 +303 2 9.87032 10.282 10.7171 2.48436 10.3271 -7.39297 +304 1 9.73405 0.807167 10.8572 20.2474 21.386 4.54274 +305 2 9.58177 18.5811 11.2204 -17.7151 -14.7389 -0.277185 +306 2 9.10878 1.03014 10.1675 -11.7891 -3.63679 -6.29284 +307 1 9.18221 15.2247 10.2123 -13.9791 -9.46207 -17.3808 +308 2 9.04674 16.0847 9.7631 0.486754 -17.6411 9.75771 +309 2 8.3908 14.6843 9.94105 18.1048 12.7648 16.7376 +310 1 1.00316 9.27987 10.329 16.2357 -30.0069 -12.307 +311 2 1.16727 10.1904 10.5724 12.5584 13.4462 -0.132091 +312 2 1.84996 8.76119 10.1498 -29.1191 35.4904 9.82697 +313 1 16.8004 4.89338 8.19813 20.3933 -12.8673 28.5682 +314 2 16.1748 5.31624 8.83318 13.8703 -8.22156 -17.3769 +315 2 17.4877 4.38941 8.71628 -28.7666 17.1718 -13.9408 +316 1 14.6379 14.6893 0.402347 -11.3933 -1.08114 12.583 +317 2 14.9609 15.3376 1.05877 1.73558 -10.8431 -5.12344 +318 2 13.9048 14.1906 0.841144 16.133 14.0369 -13.7985 +319 1 3.51181 11.0525 9.63829 3.71178 7.51059 -9.42611 +320 2 3.41507 11.3617 10.5484 4.21267 3.5616 -2.2445 +321 2 3.25155 11.8076 9.06383 -1.86739 -11.3951 3.16022 +322 1 11.0289 10.8695 1.26208 17.5529 18.9634 -6.32419 +323 2 11.1535 11.716 0.753779 -2.53448 -25.7082 13.9861 +324 2 10.1142 10.5923 1.16471 -5.76816 1.63272 -1.45278 +325 1 13.2239 7.06188 12.8977 -31.5053 10.0751 -2.41927 +326 2 14.1381 6.84046 12.8922 27.4331 -7.40558 0.979603 +327 2 12.7471 6.22139 12.9668 2.74296 5.12722 -5.48309 +328 1 9.62584 1.88878 0.937813 20.2039 -2.98483 37.6532 +329 2 8.77484 2.11506 0.623903 -27.5663 2.83673 -14.773 +330 2 10.1764 1.70882 0.191067 9.03311 -1.803 -18.3794 +331 1 10.6054 13.537 4.7508 -5.88392 -4.211 -2.61457 +332 2 11.3208 12.9359 5.04367 -2.43279 15.5075 -5.53386 +333 2 10.4128 14.1619 5.47507 10.6777 -11.2442 -5.71889 +334 1 14.2525 1.6915 10.8868 22.6682 20.2673 6.9187 +335 2 15.0842 1.26497 10.6465 -0.175006 -8.05208 -4.1062 +336 2 14.5069 2.62992 10.8824 -12.4791 -0.486299 1.09093 +337 1 14.6678 12.4248 11.7157 -13.2082 -11.6835 -6.16669 +338 2 15.5574 12.5766 11.3177 -21.8957 -10.6844 -5.73724 +339 2 14.0022 11.9667 11.1187 29.6297 15.7618 7.64488 +340 1 8.24065 5.08218 9.78509 -6.47861 44.5837 29.4664 +341 2 7.45364 5.10173 10.3836 14.047 -11.9893 -18.2698 +342 2 8.36822 4.22882 9.41503 -9.58488 -33.9934 -8.19516 +343 1 1.59893 16.8132 18.3262 1.96117 45.1636 -18.3395 +344 2 1.99225 17.1675 17.4932 -11.7114 -3.37836 17.8399 +345 2 1.72693 15.8931 18.2458 8.8364 -33.8164 2.61771 +346 1 1.43382 17.2563 15.3383 72.5903 -10.7327 -13.0674 +347 2 1.32309 18.1562 15.5759 -7.01853 28.114 11.2541 +348 2 0.623143 16.841 15.3782 -65.0193 -20.0106 1.99827 +349 1 3.73599 5.55499 6.2196 -15.153 37.171 -3.6345 +350 2 3.32092 6.26594 6.76194 -0.427016 -18.6419 -6.59332 +351 2 4.19567 6.05321 5.52665 9.16489 -2.39818 -0.177123 +352 1 12.357 9.41487 14.1826 14.7553 -23.0333 -0.513454 +353 2 12.9591 8.63784 13.9021 -31.7094 29.7183 13.6876 +354 2 11.936 9.15457 15.0346 15.6336 0.764049 -11.787 +355 1 4.0362 15.2647 6.90572 29.1452 22.7898 -8.55589 +356 2 3.45744 16.0249 6.7945 -6.03593 0.633302 -6.25525 +357 2 4.92941 15.6518 6.66696 -24.7672 -22.8121 8.07817 +358 1 0.606517 8.56128 14.8606 8.16327 11.3924 -6.42857 +359 2 0.498099 9.52604 14.9437 -1.3098 -5.53798 5.35752 +360 2 1.28855 8.50016 14.167 -7.84877 -5.15776 5.22176 +361 1 12.9763 8.3683 10.3434 -0.844759 8.90572 -31.1716 +362 2 13.7163 7.90436 9.89822 -4.62341 -2.31264 17.3373 +363 2 12.9003 8.0957 11.2534 8.39581 -13.8091 14.665 +364 1 15.2983 7.63672 3.47583 -36.1974 -22.3868 30.0346 +365 2 14.5024 7.10501 3.29647 15.8969 13.8763 -24.8874 +366 2 15.2922 7.47095 4.43335 27.1257 13.219 -1.62631 +367 1 17.3208 6.63818 0.028906 -14.8751 21.4285 -7.11338 +368 2 16.7479 6.05403 0.554933 2.23596 0.744461 -7.2242 +369 2 16.7141 7.27151 18.2009 9.57247 -21.991 17.917 +370 1 8.79355 6.92545 7.84172 -22.0329 -24.5159 21.3067 +371 2 9.63968 7.32585 7.85068 36.717 16.3192 -5.46325 +372 2 8.77688 6.39871 8.67404 -5.56167 6.19415 -17.3543 +373 1 12.3209 0.607808 1.1741 -8.60043 -0.59496 -5.94607 +374 2 12.995 1.15082 1.58835 11.0262 -7.11766 4.69751 +375 2 12.79 18.5825 0.66073 -1.01688 3.73434 3.9163 +376 1 5.68514 15.097 14.5145 8.08213 26.2607 -13.8654 +377 2 4.72797 15.1695 14.4772 -8.65505 -1.66018 8.38379 +378 2 6.02476 15.8935 14.032 -4.56821 -16.9623 16.8148 +379 1 3.822 6.53853 1.67803 10.5239 -7.29529 -10.476 +380 2 3.54968 7.33117 1.17576 -0.94291 -9.86176 19.1013 +381 2 3.81642 6.7886 2.60252 -1.1437 7.90849 5.70077 +382 1 3.89262 11.6088 12.227 12.6183 0.535598 5.61903 +383 2 4.72051 12.1032 12.348 1.21499 -6.42147 -0.654839 +384 2 3.26281 12.0921 12.7526 -15.9809 8.56892 5.74885 +385 1 5.45444 3.88172 15.8755 8.44756 62.1439 23.7417 +386 2 5.90627 3.24049 15.3708 26.1603 -31.2362 -14.1171 +387 2 6.11665 4.65725 15.9739 -35.5554 -35.0069 -5.06549 +388 1 14.4636 10.317 4.39501 5.54347 -18.2961 -43.8287 +389 2 14.9051 9.88853 5.13417 0.162303 -5.91623 3.64337 +390 2 14.7084 9.81768 3.53446 -11.8135 21.0668 42.8202 +391 1 7.94949 17.2895 9.24469 -10.6799 8.8199 -1.02562 +392 2 7.23447 17.5423 9.86969 8.35341 2.50468 -15.9799 +393 2 8.01085 17.8889 8.47627 -8.2125 1.31495 9.33291 +394 1 4.4986 14.4237 3.96317 23.4879 4.54475 27.495 +395 2 4.89523 15.3318 4.14709 -14.6852 -27.1979 0.729547 +396 2 4.80237 13.7713 4.67129 -11.1841 28.5155 -20.9146 +397 1 14.3358 7.38467 15.7635 18.2582 5.36164 1.70543 +398 2 15.2401 7.23754 15.391 -25.5283 4.5174 14.2628 +399 2 14.4998 7.83446 16.6232 -7.00614 -11.7321 -15.3353 +400 1 2.86875 18.2246 1.90934 11.7547 29.7641 47.6357 +401 2 2.54447 17.7626 1.17928 -20.4445 -34.8995 -41.4626 +402 2 2.08284 18.4154 2.45796 12.4063 3.86937 -8.17484 +403 1 7.96139 1.61197 4.52525 30.3503 -5.61589 29.1814 +404 2 7.4985 1.83317 3.72811 -5.85178 12.6793 -14.6648 +405 2 8.84188 2.051 4.57628 -22.8061 -6.44347 -10.2559 +406 1 2.69247 14.1251 17.7583 -44.9975 -8.30966 9.027 +407 2 1.78944 13.8074 18.0556 29.9332 0.951363 -12.1679 +408 2 3.33089 13.517 18.1683 -0.885538 6.08231 -6.55793 +409 1 0.711797 1.68055 13.8626 46.1903 -0.903658 -18.4125 +410 2 0.854596 1.56791 14.7929 -3.1534 -4.53792 18.4431 +411 2 18.4557 1.86826 13.7064 -36.4408 7.03813 3.66844 +412 1 4.5582 18.5986 13.9691 16.7448 -5.62304 -20.7496 +413 2 5.37614 18.0918 13.7297 -17.5024 17.6116 13.2075 +414 2 4.4096 18.4453 14.9034 -5.9637 -5.97884 8.59903 +415 1 7.10973 0.453475 18.3742 -15.9095 45.4284 35.234 +416 2 6.99644 0.098599 17.5235 1.36411 -17.312 -40.4978 +417 2 6.34312 1.05085 18.5323 11.251 -17.9428 -0.916775 +418 1 16.0934 18.4421 14.1505 -12.1616 -21.5095 -38.715 +419 2 15.444 17.7866 13.7542 19.2119 24.6311 23.4234 +420 2 16.0379 18.4915 15.109 -11.392 0.0248185 1.48898 +421 1 10.1156 4.52417 16.2956 -62.1497 -10.7811 -30.3439 +422 2 10.9808 4.34247 16.5381 55.5233 -0.530433 19.4573 +423 2 9.84863 3.69679 15.8473 1.30878 12.8229 10.5952 +424 1 15.8226 17.9425 4.41327 -8.6596 2.53656 28.4341 +425 2 16.5547 18.5732 4.53052 -7.53986 -1.28134 -1.76301 +426 2 15.1071 18.2295 5.06915 24.8326 -13.5436 -35.3744 +427 1 6.9246 17.3574 13.7412 35.4232 12.1969 -4.79491 +428 2 7.49648 17.8115 14.4369 -19.095 -19.6264 -17.6052 +429 2 7.52703 17.1963 12.9658 -8.44681 6.90552 21.4872 +430 1 13.2892 6.57209 6.73437 -47.4462 -6.01427 11.894 +431 2 14.2146 6.66317 6.83486 37.5911 0.460957 -13.6759 +432 2 13.0394 6.38579 5.82242 8.60231 0.411312 -6.48828 +433 1 7.6616 2.3861 9.17526 11.1339 -5.58665 -35.6695 +434 2 7.32169 2.39592 10.0555 -17.0215 -5.04529 20.6135 +435 2 6.95914 2.1022 8.53308 18.7558 7.43711 21.2842 +436 1 15.1464 14.8771 13.6482 -7.73724 1.21311 0.537171 +437 2 15.0308 15.0223 14.6069 -1.84691 1.26092 -11.2626 +438 2 14.3194 15.1152 13.1798 14.9291 -3.65447 11.731 +439 1 9.29105 8.34315 3.70472 21.3149 -22.535 5.81715 +440 2 10.1776 8.75859 3.73678 -10.082 3.55323 2.49013 +441 2 9.48378 7.39942 3.88081 -6.26995 14.6936 -2.40173 +442 1 17.6854 13.4687 16.4528 7.27147 30.461 -18.2669 +443 2 16.7357 13.4337 16.3398 -4.89197 -8.49248 4.47316 +444 2 17.8844 14.3284 16.0065 3.65909 -18.1112 10.9221 +445 1 5.04883 10.6547 2.58751 22.4142 -14.5409 3.1837 +446 2 5.87017 10.3468 3.04382 -22.783 5.18619 -3.79272 +447 2 4.55197 11.1441 3.22928 -6.35653 9.92745 13.9967 +448 1 3.70566 8.3683 10.3381 0.421872 -35.3081 -1.7593 +449 2 3.86061 9.29726 10.2176 3.60826 23.2513 -1.90293 +450 2 3.86652 8.14601 11.2715 -1.83662 8.64514 -7.63686 +451 1 16.1079 7.11641 6.33859 18.7251 -13.7954 -9.96454 +452 2 16.7241 7.70559 6.80408 -7.87205 -5.85527 -7.24175 +453 2 16.6678 6.33083 6.12136 -22.8952 10.0887 6.36104 +454 1 15.2027 7.00502 9.1117 -13.5711 31.2066 -33.9348 +455 2 16.009 7.42176 9.46585 -10.2898 -7.03399 -7.73296 +456 2 14.9881 7.51375 8.25647 13.8068 -20.3115 41.0185 +457 1 6.4525 13.1649 12.9201 -16.9811 1.25576 1.12717 +458 2 7.2977 12.7289 13.0561 1.55279 -4.02118 8.73008 +459 2 6.25327 13.7237 13.7059 9.12735 -9.15034 -19.1848 +460 1 12.1145 4.49786 13.0694 62.3048 41.2439 -0.723073 +461 2 12.3852 4.68406 13.9868 -14.3297 -10.0558 -0.292641 +462 2 11.3952 3.9317 13.0199 -52.2119 -35.1204 4.15665 +463 1 11.3323 8.18365 7.8522 27.7169 3.03613 12.328 +464 2 12.0901 7.73501 7.43634 -12.9205 -4.29619 -7.69129 +465 2 11.7651 8.45102 8.68662 -18.4456 -0.736999 -3.04515 +466 1 17.1666 10.776 7.42179 36.4822 -17.3878 -25.363 +467 2 17.7906 10.0723 7.08441 -17.5934 13.4566 22.3886 +468 2 17.2793 11.4524 6.73733 -15.3427 2.84073 7.18141 +469 1 5.22802 18.1471 11.05 -23.1388 -14.8798 2.48444 +470 2 4.73762 18.1049 11.901 7.4508 0.565766 -17.6495 +471 2 4.62535 17.7417 10.374 17.7336 12.8347 12.9373 +472 1 7.56653 17.6363 1.80821 4.35794 -3.26776 57.5888 +473 2 7.65741 16.7768 1.42856 9.05039 -19.6913 -22.9027 +474 2 7.35855 18.2549 1.13994 -1.37991 13.1573 -30.1972 +475 1 1.85092 12.9256 13.6076 18.7065 20.702 19.2299 +476 2 1.72104 12.4156 14.4258 -5.54537 -0.960406 -11.4426 +477 2 2.19932 13.7866 13.9501 -8.88955 -22.8153 -6.43965 +478 1 9.73868 6.79159 14.8001 -20.0718 45.6966 0.235719 +479 2 9.95236 5.95211 15.1529 12.0129 -40.6355 11.2206 +480 2 9.967 6.84408 13.8723 5.59208 -5.10263 -8.66058 +481 1 15.2087 4.3972 10.7794 -27.6923 -26.0969 -27.5028 +482 2 16.0082 3.89203 10.8637 26.1176 6.2885 5.33656 +483 2 15.2102 5.16148 11.3322 8.48984 16.211 19.3779 +484 1 11.1963 6.12482 0.150068 -21.1972 -23.7011 14.8212 +485 2 11.2381 5.20796 0.481504 11.4486 12.9471 -10.1704 +486 2 10.2374 6.21547 18.6186 14.0424 14.8346 -3.67395 +487 1 0.19533 11.3359 15.1413 -20.6703 11.3325 -28.7309 +488 2 18.4021 11.874 14.3993 9.91215 -19.3636 27.3138 +489 2 18.4481 11.661 15.9631 4.36494 9.01906 -3.16307 +490 1 7.06882 9.13032 7.26059 -19.4655 -1.24154 14.8953 +491 2 6.55985 8.40099 7.69941 12.6354 16.9737 -16.1687 +492 2 7.9725 8.82922 7.21375 8.43039 -5.65083 0.275054 +493 1 18.4578 15.4507 12.3537 3.87705 -1.0699 -4.92487 +494 2 0.776651 15.5698 12.2511 -12.7177 -2.03387 6.80581 +495 2 18.1456 15.6789 11.4721 -4.67377 -0.406651 0.743757 +496 1 16.5694 4.36967 5.25107 0.98709 -29.8421 42.9348 +497 2 16.7744 3.81151 6.06026 -19.0257 27.4778 -23.1846 +498 2 17.3898 4.32671 4.78168 15.572 7.21618 -21.1326 +499 1 17.788 3.06911 10.7078 7.64381 16.9425 17.2861 +500 2 0.075758 3.1322 11.0257 -14.4921 -2.82201 -9.29777 +501 2 17.6332 2.20749 10.3226 4.29805 -13.9207 -6.70838 +502 1 12.3142 0.064083 10.1758 -16.2036 46.6093 2.93236 +503 2 11.3746 0.384648 10.259 24.7548 -16.9496 1.0795 +504 2 12.8178 0.919304 10.3228 -10.1981 -36.9052 -8.89593 +505 1 10.3666 9.83315 12.2981 10.0643 6.74252 24.9843 +506 2 11.1015 9.85063 12.955 -7.48254 2.69098 -11.3777 +507 2 10.1328 8.91188 12.2898 -1.25875 -17.3524 -2.69444 +508 1 0.463654 2.82678 7.01839 23.1504 30.9543 10.494 +509 2 0.875324 3.58845 7.48211 -15.8261 -9.71426 -11.3384 +510 2 0.770257 2.12665 7.58365 -2.51696 -19.6875 3.88184 +511 1 0.478371 15.2358 6.91004 -5.36214 -57.1351 9.88058 +512 2 0.585298 15.6463 7.75647 2.33624 13.0536 15.0713 +513 2 0.556531 14.2524 7.18353 -2.6234 48.5984 -27.3232 +514 1 16.9534 7.00251 15.3394 -19.8576 7.98442 -8.98385 +515 2 17.6338 7.63543 15.0899 18.202 -5.57661 4.9227 +516 2 17.3093 6.19568 15.7235 12.2576 0.0838452 -6.46227 +517 1 9.0001 12.4151 8.13768 -31.7276 34.3494 27.7642 +518 2 9.37386 11.8218 7.49742 -2.69042 -17.0115 -24.8182 +519 2 8.02402 12.632 8.03373 37.271 -17.4326 -7.14384 +520 1 1.27238 1.95406 3.05803 -14.2139 -9.70678 -17.9319 +521 2 1.26084 2.61511 2.34121 0.72572 -7.36998 11.1944 +522 2 1.89031 2.22344 3.73293 7.71835 10.2015 -2.21509 +523 1 4.13907 15.1156 9.62039 -24.138 8.67184 14.727 +524 2 4.07003 15.1439 8.65747 7.76366 -2.53025 0.663124 +525 2 4.96029 14.7006 9.86457 16.019 -6.11163 -3.79055 +526 1 7.17628 2.17866 14.5671 8.05543 15.8774 -0.750343 +527 2 6.99528 1.68402 13.7698 -4.08254 -5.57585 -6.74919 +528 2 7.62131 2.98432 14.249 -3.31184 -9.11349 9.13274 +529 1 18.6082 14.7131 2.1481 32.1263 -19.3615 -2.59353 +530 2 0.838003 15.1297 2.25966 -2.55576 -5.62694 -3.02712 +531 2 17.988 15.3544 2.42675 -29.4597 23.3621 5.14018 +532 1 9.94138 2.79524 12.9422 18.0301 -20.084 -2.65944 +533 2 9.79404 2.1456 12.2228 -2.72579 10.1868 5.0837 +534 2 9.17835 3.36299 13.0326 -9.76513 7.42125 -6.32672 +535 1 2.80444 8.90955 13.0076 -21.3878 -12.6555 -0.633582 +536 2 3.06361 9.80599 12.872 11.8276 24.8177 -4.92621 +537 2 3.5122 8.48618 13.4775 16.8101 -10.8298 6.5617 +538 1 3.236 8.3574 3.63664 -3.24123 -25.7508 65.6997 +539 2 3.45085 9.0718 3.07326 14.699 31.6407 -15.7982 +540 2 3.47645 8.58669 4.60794 -10.8292 -3.55345 -46.4885 +541 1 5.62853 7.18594 8.51094 13.0444 23.9613 2.26298 +542 2 5.46784 6.31815 8.13889 -4.11832 -12.799 10.1434 +543 2 4.96415 7.47792 9.15047 -6.22666 -11.1251 -0.517113 +544 1 14.8757 1.26039 2.01768 6.89853 7.12439 -27.6668 +545 2 14.9353 2.01952 2.56559 -6.08088 15.4811 28.5729 +546 2 15.2784 1.60993 1.21235 -3.12956 -15.001 -5.59525 +547 1 8.22892 15.2012 0.850139 9.01324 -8.86779 5.43529 +548 2 9.02213 14.9338 1.33488 4.41045 13.1537 -1.08033 +549 2 7.55366 14.6663 1.27665 -10.9347 0.418265 -6.06235 +550 1 15.6387 1.34587 7.23673 -34.4855 -14.424 -6.72803 +551 2 14.9277 0.724731 6.91269 25.2779 16.6902 6.4887 +552 2 15.1173 2.1119 7.53894 8.3028 -0.775331 -5.89355 +553 1 4.90142 13.0959 18.5232 17.5611 -6.682 24.5871 +554 2 5.32755 13.082 0.76977 -9.23128 1.69535 -18.7742 +555 2 5.44764 13.7122 18.0259 4.92611 -3.73779 -6.82361 +556 1 15.3368 8.46948 18.1479 24.407 23.6523 -18.6734 +557 2 15.8061 9.12264 17.5623 -15.0725 -19.5419 9.94084 +558 2 15.3318 8.91689 0.353875 -7.67765 1.6761 7.06822 +559 1 12.0708 3.01842 18.3809 -8.57811 34.9919 -15.9288 +560 2 11.9316 2.65996 0.60646 7.37996 -15.8634 5.79137 +561 2 12.6022 2.47389 17.7995 4.55547 -17.8211 5.72515 +562 1 13.2139 12.6752 5.17768 -11.8856 9.18106 -10.9384 +563 2 13.7464 12.0348 4.69253 2.29692 -7.56952 8.05888 +564 2 13.2564 12.5123 6.11793 11.0077 -2.72782 9.02039 +565 1 6.05443 7.0356 0.031519 0.145276 -19.8641 5.27909 +566 2 5.93935 7.95118 18.5019 2.68887 36.361 -1.99394 +567 2 5.39095 6.86665 0.702638 -10.5375 -11.3291 0.555603 +568 1 17.7528 16.0276 15.0213 -26.9751 8.08167 9.65398 +569 2 16.9476 16.5457 15.105 2.62193 -2.13449 20.9775 +570 2 17.7479 16.0055 14.0813 23.0391 -15.2709 -33.7916 +571 1 13.196 0.994907 16.5363 6.64944 3.5152 15.0268 +572 2 14.1481 0.997912 16.7614 -13.0846 -5.94027 -6.50206 +573 2 12.8833 0.094199 16.7238 3.13951 3.25376 -8.62791 +574 1 11.1253 14.5647 7.20271 12.6179 20.8985 -18.374 +575 2 10.4007 14.3183 7.72981 -32.928 -10.0181 24.5345 +576 2 11.7186 13.8255 7.26943 16.9686 -3.76464 3.70387 +577 1 17.5081 8.62849 2.08107 18.4536 39.9223 21.5452 +578 2 16.6801 8.63471 2.55495 -14.8656 -12.3201 1.9096 +579 2 17.5233 7.88242 1.516 -5.44609 -31.2556 -23.2052 +580 1 12.3547 8.01168 2.02213 3.34817 7.10659 0.607451 +581 2 12.2384 8.8582 1.54611 -2.17098 -11.1853 7.9144 +582 2 11.9739 7.3152 1.48261 -5.38076 0.52639 -15.2068 +583 1 11.8761 14.6165 10.3364 1.47614 -26.5661 -12.796 +584 2 12.1004 13.7873 9.81464 -15.4397 33.1565 21.8304 +585 2 10.8993 14.6888 10.473 20.8283 -4.95583 -12.7008 +586 1 6.89524 7.05211 15.6117 0.948881 6.37495 10.6055 +587 2 7.81004 7.26536 15.3122 -15.6925 -0.985911 8.93516 +588 2 6.66676 7.54167 16.4408 13.3623 -9.35483 -24.2683 +589 1 8.00326 4.73593 13.4743 46.4542 16.9938 22.3473 +590 2 7.23337 4.7302 12.9572 -38.0428 3.58552 -28.1525 +591 2 8.40671 5.62958 13.343 -10.0413 -24.497 3.68285 +592 1 13.4128 12.1818 14.2522 -5.09814 -0.706424 13.2965 +593 2 12.9414 11.3292 14.2657 9.08717 -0.174959 -7.02282 +594 2 13.7875 12.315 13.3696 0.74786 -2.13255 -0.749325 +595 1 14.8395 9.42189 7.30548 -8.6508 -34.4179 -15.7659 +596 2 15.7087 9.765 7.42505 16.3683 18.0856 5.12693 +597 2 14.2269 10.0768 7.57319 -16.6679 19.7312 11.3719 +598 1 12.6526 17.0686 3.07252 -27.098 39.8252 10.9251 +599 2 12.8376 17.5237 3.93373 4.63929 -18.9198 -22.9156 +600 2 11.9913 17.6958 2.63477 30.4514 -31.1971 13.898 +601 1 1.15545 7.13838 17.4647 3.17244 9.59861 -23.4243 +602 2 0.330359 7.36323 17.9184 0.96629 -9.78644 0.159833 +603 2 1.05514 7.47868 16.5422 0.732192 -3.11516 17.9471 +604 1 12.7562 5.15096 15.6457 43.4314 -6.34677 13.892 +605 2 13.4512 4.55662 16.0315 -22.7809 11.2033 -14.7919 +606 2 13.2414 6.00335 15.5788 -11.6166 -6.13865 2.23982 +607 1 2.53993 3.38757 4.97618 -22.6627 40.6834 48.2045 +608 2 1.7609 3.18232 5.58922 26.9518 1.19035 -20.1247 +609 2 2.84154 4.31546 5.27885 -5.90416 -46.089 -11.2441 +610 1 8.33186 11.2983 13.4548 -26.6082 5.68838 43.1719 +611 2 8.4244 11.0562 14.4444 7.75654 0.873515 -50.9507 +612 2 8.91168 10.8786 12.8197 22.3442 -13.0535 12.4472 +613 1 12.8689 1.31514 13.3384 2.90045 58.5941 -12.9641 +614 2 13.42 1.58034 12.5659 -7.54964 -19.9936 10.3698 +615 2 12.4231 2.17844 13.5496 8.73522 -32.0886 -3.11014 +616 1 6.34008 13.7169 2.14963 -18.1698 -8.87317 18.5321 +617 2 5.63978 13.877 2.82959 15.2612 6.49493 -20.3543 +618 2 6.88351 13.0442 2.56282 10.2537 -4.17084 0.110729 +619 1 15.9206 6.61444 12.7992 -24.6515 -28.5257 0.353752 +620 2 16.3106 7.25195 12.2393 18.8127 19.5603 -18.6955 +621 2 16.4213 6.59661 13.608 8.17022 1.84551 14.3752 +622 1 16.8298 0.712824 9.59482 4.92561 -19.6459 1.56363 +623 2 16.8791 18.3713 9.72616 -6.7933 22.7031 -2.37673 +624 2 16.5452 0.8605 8.67269 -3.47063 -2.57745 5.28583 +625 1 6.14624 11.7631 8.37671 0.810232 -55.5778 6.71556 +626 2 5.32447 11.4591 8.84151 13.2611 12.3623 -11.7456 +627 2 6.64226 10.8931 8.20176 -18.8432 36.5086 0.169281 +628 1 2.88754 8.61261 0.453821 16.629 -12.4076 -25.9584 +629 2 2.45212 8.04764 18.3917 -7.9132 30.8844 23.5565 +630 2 2.34875 9.28564 0.895642 -16.9187 -4.58083 -11.1609 +631 1 10.1674 10.4623 6.50123 2.03347 0.962837 -14.0367 +632 2 10.6087 9.69731 6.89122 -0.033473 -1.16532 5.68604 +633 2 10.4694 10.4636 5.56932 -4.02396 0.831062 14.2442 +634 1 6.7142 15.6951 6.55167 21.2433 7.58031 13.0519 +635 2 7.14328 16.1838 7.27089 -7.64643 -7.38759 2.93585 +636 2 7.21237 16.006 5.79102 -10.2318 7.90387 -13.7372 +637 1 6.445 13.1807 5.57797 -4.95716 -23.6388 -1.26087 +638 2 6.7301 13.9465 6.07331 -1.77634 9.04977 6.94523 +639 2 6.09943 12.5433 6.22286 1.34041 6.33507 -0.553394 +640 1 16.8242 12.5629 9.83758 4.06472 -20.7324 4.78658 +641 2 16.9985 11.8651 9.16533 -5.27225 15.8277 3.76725 +642 2 16.5644 13.3844 9.42716 1.03985 5.07871 -11.9 +643 1 6.03738 2.95058 2.86354 -7.03855 -25.5492 -1.19629 +644 2 6.40977 3.757 2.57075 15.9289 34.7492 -4.17594 +645 2 5.57703 2.61747 2.09059 -4.9021 -9.32473 -6.53819 +646 1 10.9114 3.33767 3.30112 5.22699 -4.50477 6.26496 +647 2 10.297 4.02722 3.58926 -1.95634 -6.20434 -4.73409 +648 2 10.5127 2.84524 2.57795 -5.80356 2.60284 -4.41077 +ITEM: TIMESTEP +10 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.68613 7.08001 17.9478 -7.01358 -5.91592 2.73538 +2 2 7.77987 6.83016 18.2266 16.0785 4.58355 -9.56375 +3 2 8.81561 6.77572 17.042 -2.60158 -2.67368 4.89818 +4 1 18.5411 8.25019 6.8397 -3.31911 20.0829 53.2463 +5 2 0.132112 7.95881 5.98338 15.0803 -17.7916 -37.9407 +6 2 0.419079 7.77779 7.52768 -3.57438 0.834533 -17.4022 +7 1 8.38502 18.5543 6.8162 17.8503 9.74549 -0.663478 +8 2 9.33656 0.12202 6.71165 -15.3958 -3.25669 1.14423 +9 2 7.91896 0.595612 6.31609 0.0971505 0.0480551 2.20998 +10 1 6.59239 1.84347 11.7106 33.6248 -3.3918 -11.5419 +11 2 5.88602 2.36507 12.0365 -24.0057 14.4643 13.3031 +12 2 6.19621 1.03555 11.4016 -9.54455 -15.1367 -3.43817 +13 1 7.13469 5.75647 2.33282 -16.0707 1.2807 18.6339 +14 2 6.47472 6.10605 3.02238 22.3175 -2.25238 -34.2201 +15 2 7.09016 6.23688 1.47486 -10.0175 -2.52095 21.7818 +16 1 16.2156 10.1493 16.1334 -27.9935 4.46583 14.8083 +17 2 17.0011 10.2168 15.6173 19.2784 7.57164 -10.1711 +18 2 15.8457 11.0427 16.2776 9.29404 -6.61316 -4.9073 +19 1 10.6069 15.0238 2.30809 -6.31705 -20.7544 -7.43742 +20 2 10.5597 14.4327 3.07214 -0.102442 0.508968 4.74876 +21 2 11.0526 15.7982 2.62807 10.1844 15.1967 6.36644 +22 1 17.1594 8.2489 10.3903 7.52685 0.546464 5.9579 +23 2 16.5819 8.79937 10.9325 -0.0424193 4.91704 3.34034 +24 2 17.9857 8.74574 10.257 -6.36369 -4.03495 0.916497 +25 1 14.8922 15.8683 16.3299 23.5339 -10.8154 7.03311 +26 2 14.0097 16.1903 16.2206 -28.4756 7.26009 1.81472 +27 2 14.9055 15.3621 17.1614 -4.45807 1.9077 -0.883551 +28 1 12.1657 13.3863 0.41518 7.67499 -13.0963 13.9948 +29 2 12.1102 13.7181 18.1579 -7.06431 5.66946 -3.72811 +30 2 11.6673 13.9211 1.04936 -4.85696 8.50836 -7.81927 +31 1 9.27628 5.36844 4.05123 -34.192 4.59602 9.65195 +32 2 8.65917 5.24858 4.84371 24.3198 3.71877 -28.2857 +33 2 8.65376 5.51218 3.29446 11.8948 -3.58803 14.2972 +34 1 1.82985 4.27304 11.6494 -12.5424 24.0017 -6.14821 +35 2 1.72713 5.22025 11.9335 1.67264 -20.3932 -8.37626 +36 2 2.38183 3.84857 12.2925 10.2742 -10.1374 14.5925 +37 1 1.96666 6.8371 8.3675 -1.07206 -9.37897 -7.64517 +38 2 2.48137 7.16021 9.09528 7.6819 14.0614 11.7347 +39 2 1.91994 5.89719 8.57067 -2.65468 -6.85216 -5.3032 +40 1 5.40566 4.39875 7.93795 -15.0212 -10.7202 -17.6012 +41 2 5.47911 3.43644 7.82861 5.00513 7.47325 10.3929 +42 2 4.74947 4.60653 7.2496 8.53973 6.88839 10.8311 +43 1 3.24286 2.9209 17.5475 -3.50993 31.6723 15.8788 +44 2 3.91538 3.33593 16.9792 1.14815 -4.85754 -1.50754 +45 2 2.90196 3.68515 18.1088 4.46159 -27.603 -16.229 +46 1 7.46543 5.27113 6.11173 -0.267366 -14.8618 42.036 +47 2 7.89952 5.61794 6.92737 -2.28349 10.3868 -28.0837 +48 2 7.00366 4.5014 6.50229 0.780861 12.0869 -17.1147 +49 1 9.7753 7.01959 11.9799 12.4421 -0.327694 33.7281 +50 2 10.3285 6.37932 11.5448 5.34489 -7.46932 -11.0014 +51 2 9.14168 7.33293 11.3548 -18.5265 5.10994 -23.2436 +52 1 14.1114 3.54906 8.03925 -21.2079 2.70274 -24.764 +53 2 13.5379 4.24737 7.67406 9.42135 -8.95765 0.532077 +54 2 14.4057 3.90023 8.85862 11.8721 11.0917 26.6467 +55 1 4.80077 17.263 4.02669 -14.2573 4.92943 -10.2324 +56 2 5.55275 17.8868 4.11075 -15.7048 -9.31229 -6.31173 +57 2 4.21849 17.485 3.25536 16.798 3.03083 13.1086 +58 1 16.5008 16.6241 10.052 9.35033 0.377019 -20.0251 +59 2 16.0742 16.3966 10.8515 -13.0635 -0.25069 32.9814 +60 2 15.9476 16.1716 9.40786 2.84148 0.00630379 -7.36632 +61 1 1.95698 4.92664 0.48601 10.6785 6.17321 -0.923017 +62 2 2.54546 5.28332 1.19783 -10.1544 -3.94981 -19.1082 +63 2 1.86706 5.64777 18.4726 -0.259245 -4.73099 10.3692 +64 1 11.8035 13.3621 16.2801 -12.0315 -31.2076 -16.8087 +65 2 11.3006 12.5351 16.4295 -1.37085 13.2186 10.8936 +66 2 12.2283 13.1244 15.4353 5.36339 15.8055 8.10642 +67 1 10.1086 11.0623 16.95 16.2363 -23.6439 1.11167 +68 2 10.572 10.1938 17.105 -14.3776 22.5927 -6.24497 +69 2 9.21542 10.8357 16.6616 -0.160324 -0.0991661 2.29857 +70 1 11.7231 17.5369 13.4667 -11.0418 -25.624 2.08744 +71 2 12.2825 16.9797 12.896 1.06573 10.1819 1.6514 +72 2 12.0497 18.4302 13.3866 8.679 12.3703 -3.21063 +73 1 6.34404 9.31427 12.2267 -10.7289 -25.2447 -16.4149 +74 2 6.95388 8.98312 11.5319 -2.39052 10.1346 10.7157 +75 2 6.76108 10.0063 12.722 17.2241 14.9443 4.4156 +76 1 16.2191 12.7237 2.7003 -6.42998 -13.8373 4.3175 +77 2 16.9936 13.1939 2.44509 26.0904 7.71252 -7.79508 +78 2 15.5637 13.4111 2.72948 -20.2851 11.8065 3.04981 +79 1 0.635855 12.5646 5.86231 -29.6975 10.9384 -12.0161 +80 2 0.906184 12.4779 4.92975 2.15237 -1.21985 12.1118 +81 2 18.3245 12.8391 5.75844 29.6273 -11.2198 7.31028 +82 1 5.19222 16.3868 18.4948 24.5889 -0.529385 -6.85369 +83 2 5.88953 15.8781 18.0466 -13.534 -2.69513 -2.10794 +84 2 5.71609 16.8872 0.480999 -10.5805 4.6302 6.45748 +85 1 0.515864 7.62939 4.0653 41.0474 19.9956 -23.6294 +86 2 18.5677 8.05158 3.40199 9.2753 -7.28591 11.0746 +87 2 1.47269 7.84683 3.73678 -46.4137 -9.00167 19.6367 +88 1 3.14217 8.89553 6.52533 -39.0459 6.50689 -6.5056 +89 2 3.57285 8.63007 7.33767 0.0694837 -1.26665 5.56399 +90 2 2.14756 8.93745 6.67407 38.5311 -3.64433 -0.906695 +91 1 7.31414 10.3036 16.1763 -22.1518 3.21861 21.8391 +92 2 6.53268 10.4772 15.6415 8.43374 -0.0418936 -5.11234 +93 2 6.92709 10.2964 17.0866 13.3044 -2.27208 -10.5118 +94 1 11.1096 1.06093 5.00144 -6.80657 -2.48033 -19.8934 +95 2 11.1672 1.90146 4.5306 6.84499 7.0717 9.43568 +96 2 10.7236 0.515071 4.29558 2.64862 -9.02148 12.7331 +97 1 4.44354 2.70015 13.2121 -7.85281 -5.62302 -11.5877 +98 2 4.59136 3.20795 14.0303 0.103412 -15.4758 0.294405 +99 2 4.3686 1.71349 13.3622 2.85998 26.6352 12.1157 +100 1 8.41457 10.0307 1.78829 1.66015 -12.4273 17.1623 +101 2 8.40835 10.6665 2.53096 -1.47245 -0.417386 -5.09881 +102 2 8.60407 9.1525 2.20287 -3.10051 22.5249 -10.5265 +103 1 10.5229 1.75436 15.5533 -10.8574 -2.31 -4.36647 +104 2 11.4367 1.69676 15.8141 13.1269 -3.82494 7.61076 +105 2 10.5487 1.84704 14.5957 -9.26118 2.80358 -1.94415 +106 1 2.76968 12.9399 7.75003 -7.62511 -10.5749 7.18171 +107 2 3.32023 13.5874 7.29614 -2.30989 2.01815 -3.81018 +108 2 2.03946 12.7099 7.15165 5.79412 3.19458 -2.23462 +109 1 3.64251 11.6901 5.3273 -16.0178 -10.9709 -3.95767 +110 2 3.35804 11.041 6.0007 8.31372 10.277 -11.7948 +111 2 2.86611 11.8409 4.75105 13.6859 -0.281218 5.78901 +112 1 6.88155 14.4797 16.8524 -8.387 2.95998 -0.938339 +113 2 7.57426 13.8507 16.6622 5.60788 -2.76391 3.60002 +114 2 6.54738 14.7428 15.9834 -3.14908 -1.19839 3.78249 +115 1 14.1759 14.5423 3.40785 14.1775 -0.803279 -11.9449 +116 2 13.6583 15.316 3.2037 -5.78511 13.0134 -4.56688 +117 2 13.7723 14.1777 4.18517 -7.95121 -12.1195 11.7606 +118 1 8.26975 18.1784 16.0718 57.0984 -9.85256 5.13508 +119 2 8.90468 17.4721 16.3223 -30.0265 -6.05197 -2.08742 +120 2 8.93252 0.246004 16.0158 -21.102 13.2242 -8.22396 +121 1 4.73201 1.6168 4.90814 8.59128 29.3629 -19.7592 +122 2 3.91099 2.13549 5.04668 12.4977 -9.17326 -4.88478 +123 2 5.26431 2.14928 4.23236 -22.3039 -21.7635 28.9569 +124 1 15.1182 12.8405 16.4381 19.169 -3.61406 36.631 +125 2 14.6612 12.9963 17.2965 -1.87916 -0.605635 -21.6052 +126 2 14.5331 12.7051 15.7087 -30.2626 -2.71441 -16.8094 +127 1 15.786 18.3864 16.793 25.1295 13.8681 33.7963 +128 2 16.4578 18.6099 17.5315 -31.6416 -14.5347 -31.3905 +129 2 15.6162 17.4305 16.8164 1.02724 4.80811 3.46398 +130 1 1.14089 1.13731 16.5539 1.05247 19.7088 19.8175 +131 2 1.92337 1.60495 16.9036 -3.97271 -4.80748 -10.3705 +132 2 0.461096 1.48073 17.164 6.66439 -11.1518 -10.5802 +133 1 18.0862 4.58432 15.8734 11.1688 -12.2484 -2.69667 +134 2 18.5694 3.95442 15.2994 -8.21946 11.4291 8.6944 +135 2 18.5872 4.69164 16.6898 0.203498 -2.64567 -2.95902 +136 1 12.2303 16.9505 16.1288 -38.2728 -13.2591 26.8237 +137 2 11.3888 16.5791 16.5378 36.1694 7.82178 -3.50336 +138 2 11.9114 17.1502 15.2549 6.78701 5.10115 -22.4581 +139 1 15.8814 2.54765 17.9709 5.97775 7.55467 -0.319093 +140 2 15.7733 3.43717 18.3784 -1.8513 -17.3861 -11.5789 +141 2 15.6471 2.5946 17.0126 2.53833 6.86428 19.1803 +142 1 6.70799 13.8021 10.253 -1.58408 1.43394 8.76454 +143 2 6.59288 13.5189 11.1728 1.36627 8.87991 1.27306 +144 2 6.58321 12.9942 9.75946 1.30239 -6.02422 -13.3165 +145 1 10.1413 18.2148 2.80353 9.44086 30.3012 -19.3156 +146 2 10.2266 0.305071 2.14691 0.267733 -14.8877 14.3982 +147 2 9.27777 17.8669 2.60695 -13.096 -6.5965 0.845742 +148 1 2.97176 17.7529 6.06326 -6.30899 -0.645097 35.0899 +149 2 2.08427 17.6133 5.69483 9.57331 2.68214 -12.771 +150 2 3.63239 17.8017 5.37586 1.28926 -2.69105 -18.2517 +151 1 12.5668 16.9974 7.96757 -20.2971 -18.5655 21.3419 +152 2 11.8856 16.2971 7.95074 9.26888 3.31932 -10.856 +153 2 12.3344 17.4798 8.78306 11.437 7.92329 -7.28752 +154 1 14.8861 15.2795 8.28974 -15.7554 0.3814 10.2226 +155 2 14.0374 15.7294 8.25106 -5.80199 2.88483 11.5438 +156 2 15.1981 15.4683 7.42207 26.2963 -2.4275 -26.3232 +157 1 17.5473 18.3112 0.374559 -18.2134 -6.45531 -4.6775 +158 2 18.2634 17.761 0.12213 22.8374 -25.4457 -15.3465 +159 2 17.9951 0.303427 0.894204 5.3706 29.2695 18.8411 +160 1 0.910079 10.3754 1.4141 -19.386 -45.7403 28.0244 +161 2 0.0926857 9.86966 1.69283 27.9138 11.9581 -5.7438 +162 2 0.554372 11.07 0.90565 -10.4877 37.4892 -28.5805 +163 1 1.56425 12.1843 3.32385 10.4497 17.8757 14.7846 +164 2 1.39557 11.5297 2.67534 -6.58566 -33.3087 -13.0061 +165 2 1.62643 12.9551 2.76927 3.66066 18.4363 0.784965 +166 1 0.55148 17.2559 4.87768 14.7947 16.704 -22.83 +167 2 -0.0171494 17.9122 5.24737 -12.9669 22.3753 -0.718336 +168 2 0.416337 16.5086 5.40997 -1.38762 -39.6682 22.4532 +169 1 1.10468 1.00284 9.3945 22.843 10.0615 -6.85845 +170 2 1.39907 0.698807 10.2625 -7.65597 -6.79115 6.92044 +171 2 0.213465 0.701839 9.27091 -15.6194 -8.53979 4.03703 +172 1 16.7947 2.33154 13.2859 2.87858 8.18604 -25.1476 +173 2 17.0129 2.55787 12.3417 -6.42954 -5.0835 25.2497 +174 2 16.4749 1.41822 13.3005 0.0523867 -3.46078 1.59731 +175 1 2.46566 15.827 12.1934 26.7468 -10.5365 13.2985 +176 2 2.93451 15.5288 13.0073 -9.90545 6.65681 -19.023 +177 2 2.95128 15.4495 11.4346 -3.9234 5.36807 1.6728 +178 1 16.4371 15.5461 5.94503 -4.66267 19.6238 -8.97399 +179 2 17.3612 15.5093 6.28134 -9.63254 6.93473 -7.38316 +180 2 16.3109 16.2991 5.29174 10.2179 -16.1602 20.4085 +181 1 5.84392 5.02209 11.7979 1.85982 -4.44524 -6.98506 +182 2 5.51366 5.87933 12.041 -2.35542 15.5447 8.97079 +183 2 5.10963 4.44446 12.0068 -1.26359 -10.5886 0.396425 +184 1 15.2223 4.8645 0.724291 -23.0156 -11.391 23.7803 +185 2 14.7624 4.52384 1.55825 21.1304 12.2284 -22.5635 +186 2 14.5125 5.05103 18.7394 0.751055 2.39009 4.23042 +187 1 16.343 16.2984 2.11648 10.3227 5.9227 -27.7144 +188 2 16.0112 16.8052 2.83865 -11.2354 10.0489 28.078 +189 2 16.6417 17.0002 1.51324 -1.84363 -9.29214 0.277829 +190 1 0.300695 4.8777 3.79796 -11.7144 38.8206 3.66766 +191 2 0.319109 5.88664 3.94702 6.24107 -45.2605 -6.61048 +192 2 1.15751 4.50056 4.01017 2.49534 2.82459 2.96224 +193 1 2.92353 14.9884 15.0405 10.7548 -7.33568 16.7257 +194 2 2.98085 14.609 15.9661 -8.47597 15.0336 -19.5599 +195 2 2.47925 15.8529 15.1074 -0.728265 -0.613609 8.13891 +196 1 1.11951 14.5697 9.5576 17.0302 46.4745 -20.2694 +197 2 2.08903 14.5584 9.38425 -20.4257 -12.3501 8.75388 +198 2 0.805573 13.7616 9.91809 5.52927 -28.6811 10.8766 +199 1 13.6617 16.6633 11.5459 -10.7506 10.3565 -21.4971 +200 2 13.3218 17.4276 11.0158 5.92664 -14.8533 17.3679 +201 2 13.3915 15.8986 11.0154 -3.11899 -0.859159 7.39997 +202 1 4.73366 1.47986 0.719369 -25.3145 -4.02421 3.51446 +203 2 4.15092 1.98399 0.125941 8.58395 1.79335 0.854136 +204 2 4.09918 0.853913 1.13528 12.7275 2.9151 -0.0185569 +205 1 1.42442 18.4742 11.9045 -6.93945 20.4545 -13.991 +206 2 1.2372 0.390371 12.6666 -0.822965 2.19478 3.53324 +207 2 1.89543 17.725 12.2367 7.95706 -17.4489 5.30436 +208 1 11.5469 10.1058 4.11116 26.1716 14.4711 -26.2735 +209 2 11.5284 10.5631 3.21886 -3.69376 -13.1884 23.9867 +210 2 12.5118 10.0773 4.36205 -26.1062 -0.534026 -7.20275 +211 1 8.37237 12.1712 3.75254 -13.3709 24.5961 46.1376 +212 2 9.17249 12.5936 4.11701 3.41223 -8.92861 -19.033 +213 2 7.75234 12.4533 4.48752 5.20668 -18.7884 -32.053 +214 1 14.3233 4.03204 3.29282 11.0049 6.10018 19.4579 +215 2 14.9517 4.19348 4.04461 -8.72763 -4.53117 -18.7735 +216 2 13.4979 4.46304 3.56838 3.12416 -1.49393 -3.31976 +217 1 5.58139 1.77074 7.50691 -36.613 -47.7339 30.604 +218 2 4.96189 1.1025 8.02564 35.7201 38.4984 -27.3817 +219 2 5.38779 1.57566 6.57729 1.13697 3.96791 -6.02851 +220 1 17.9042 1.1171 4.88471 6.84957 17.1887 -7.45832 +221 2 18.4571 1.56865 4.21188 -4.6905 -14.0516 5.22121 +222 2 17.737 1.81424 5.53024 -1.96776 -6.02251 3.4729 +223 1 6.82733 9.39684 4.48845 1.87187 -0.890058 -10.0607 +224 2 6.84716 9.53076 5.42818 -7.08772 5.76802 18.8049 +225 2 7.72364 9.08838 4.32443 4.93667 -1.85919 -9.57362 +226 1 2.70107 14.964 1.9632 9.79064 -8.50271 -23.1477 +227 2 3.33865 14.7342 2.63816 0.0868029 -0.794049 11.9475 +228 2 3.17782 14.7454 1.13419 -13.4 8.87294 12.5953 +229 1 17.2782 12.8964 13.1387 8.1593 -36.3772 6.82198 +230 2 16.3556 13.1177 13.3173 4.03584 18.7537 -2.31465 +231 2 17.8303 13.6552 12.9439 -8.38561 20.0322 -1.78655 +232 1 15.018 10.5797 1.38541 -30.6488 -33.8734 -22.7761 +233 2 15.5405 11.2097 1.82354 25.6355 33.1541 21.1587 +234 2 14.2986 11.0703 0.97193 1.92599 -0.723232 4.24038 +235 1 5.71261 6.94641 4.5266 2.6516 -23.4686 10.5302 +236 2 5.87991 7.88124 4.41392 4.1014 10.4162 -0.896017 +237 2 6.40034 6.62744 5.14459 -6.91809 0.316355 -6.72793 +238 1 8.10894 8.26231 10.1757 -1.61977 4.99166 17.0229 +239 2 8.63366 8.87039 9.65704 12.8257 12.1371 2.09156 +240 2 7.5873 7.82886 9.51802 -16.026 -14.2044 -11.4362 +241 1 13.5265 18.2929 5.80397 -22.7677 -1.43199 15.791 +242 2 12.744 0.210577 5.63003 6.52185 -0.137688 -2.34328 +243 2 13.224 17.7307 6.55929 8.82644 11.7072 -16.2211 +244 1 0.31998 2.55606 0.111337 -23.7151 48.4906 1.53453 +245 2 18.006 2.70756 18.6319 7.21623 -15.3908 0.76394 +246 2 0.639493 3.49242 0.214062 7.71863 -30.3236 1.31164 +247 1 12.6438 10.9651 9.76843 -27.6007 42.776 -15.0826 +248 2 11.6462 10.8587 9.68427 36.5826 -6.8361 3.61513 +249 2 13.0097 10.1328 10.024 -0.792921 -29.0746 6.76076 +250 1 0.78357 12.2825 11.0843 20.7577 -6.91251 -2.74458 +251 2 18.4749 12.2741 11.1385 -12.0685 2.84404 7.0736 +252 2 1.15918 12.6384 11.9096 -11.1326 -3.84191 -3.75479 +253 1 5.04379 7.22322 13.4829 1.39832 5.89977 -6.97466 +254 2 5.58123 7.93479 13.1271 0.448534 7.96016 -10.0051 +255 2 5.53384 7.00565 14.2746 1.03136 -7.66768 11.7435 +256 1 1.27874 6.97532 11.834 -32.074 -43.2189 -14.0481 +257 2 0.482678 7.18669 11.3131 10.1443 0.561183 6.98996 +258 2 1.70367 7.78255 12.0103 18.1825 36.8435 9.31001 +259 1 15.4541 9.47267 12.3132 5.88964 23.7827 6.22024 +260 2 15.5166 10.4677 12.3686 -5.40153 -30.7713 4.20372 +261 2 15.4815 9.07432 13.2056 -1.6395 12.2138 -11.1334 +262 1 16.6425 12.9485 5.45228 -24.7761 13.2233 -32.5849 +263 2 16.3124 13.8685 5.42836 11.1894 -7.98651 20.9726 +264 2 16.4187 12.7313 4.52305 11.1313 -16.3356 15.5726 +265 1 6.1733 10.0557 0.193027 -12.4899 -11.5053 -32.3049 +266 2 5.38495 10.4604 0.58061 6.43577 -0.470902 4.897 +267 2 6.88008 10.1049 0.827544 12.5305 3.42311 14.2724 +268 1 12.3659 6.05415 4.04188 -22.1763 -21.8278 15.5685 +269 2 12.3683 6.79715 3.46108 4.13216 24.0909 -16.7914 +270 2 11.421 5.79287 4.05326 15.4186 -0.211849 3.77561 +271 1 0.132582 12.8231 0.203992 -0.195483 1.63508 -4.90635 +272 2 -0.0245094 13.5503 0.825031 2.49545 -1.98409 0.771993 +273 2 18.2458 13.055 18.0666 5.13636 -1.5464 3.82803 +274 1 3.83888 18.5816 8.61379 -9.81831 -4.88162 -16.6552 +275 2 3.52001 18.2631 7.75085 8.43173 -4.7192 1.01067 +276 2 3.03206 0.305129 8.96677 -7.80256 7.43459 9.99927 +277 1 7.39556 17.2738 4.45596 16.9172 12.0122 12.5371 +278 2 7.99849 17.9848 4.79149 -15.6229 -16.9846 -19.2965 +279 2 7.33818 17.3251 3.48629 6.36463 5.57381 8.87833 +280 1 9.21998 17.0388 12.2284 15.8258 3.83046 11.207 +281 2 9.35195 16.1931 11.7423 2.16771 12.8413 7.7779 +282 2 10.0104 17.2216 12.8137 -16.5375 -11.854 -19.0408 +283 1 13.3184 13.0063 7.94019 -19.3301 -32.807 5.85066 +284 2 13.1883 12.2647 8.56801 -4.60418 3.91603 -7.64254 +285 2 14.1459 13.3708 8.19821 21.3317 21.1541 5.11013 +286 1 14.9844 2.95035 15.3504 8.07249 -1.73557 -24.8008 +287 2 14.3 2.40675 14.9389 -0.805511 -1.63288 7.60525 +288 2 15.6705 2.98762 14.6436 -9.05507 2.69068 16.8604 +289 1 9.85476 15.5033 17.004 5.70996 8.22456 -10.0233 +290 2 10.2769 14.6753 16.7296 0.407564 1.12786 2.5917 +291 2 9.2992 15.3275 17.7693 -4.49302 -4.18434 5.79618 +292 1 11.2887 8.25054 16.5462 4.3815 15.8935 1.4126 +293 2 10.7498 7.72178 15.9677 -11.4268 -3.01506 -11.0903 +294 2 11.7109 7.60541 17.1026 7.03572 -6.39426 11.2088 +295 1 3.78312 18.1923 16.7229 -8.20319 16.8802 -14.09 +296 2 4.23544 17.5706 17.2928 8.99584 -2.65396 14.876 +297 2 3.78517 0.451969 17.0887 5.65759 -16.2586 2.71634 +298 1 2.1977 4.10819 8.95021 24.5715 -13.8141 31.6135 +299 2 3.03624 3.61916 8.82088 -15.7399 12.2693 -11.2697 +300 2 2.14197 4.07166 9.94067 -11.3718 7.67499 -23.2123 +301 1 9.90974 10.3516 9.73776 -22.8793 37.5197 3.40937 +302 2 9.44348 11.1923 9.4561 16.1923 -27.4723 -0.755713 +303 2 9.93951 10.4177 10.7077 4.76489 -7.47333 -8.73237 +304 1 9.73601 0.810068 10.8572 -6.50885 -0.835519 -1.39877 +305 2 9.40585 18.6129 11.1735 2.22486 -11.7661 13.7712 +306 2 9.0915 1.01857 10.1847 -1.93261 14.5334 -11.6688 +307 1 9.19364 15.2092 10.2107 -23.0073 -10.2994 -8.74256 +308 2 8.9841 16.0542 9.76587 1.98806 -14.8547 5.4661 +309 2 8.35152 14.6762 10.1166 22.3916 12.2872 5.93767 +310 1 0.995532 9.29186 10.3281 47.9462 -2.63812 -8.64675 +311 2 1.22741 10.2031 10.5086 -13.3799 15.5027 2.96196 +312 2 1.9063 8.9262 10.1621 -35.7029 0.949407 3.82346 +313 1 16.813 4.88766 8.1932 11.5161 -10.5322 32.9144 +314 2 16.1615 5.34773 8.77307 11.8935 -6.11126 -18.0819 +315 2 17.4051 4.37395 8.80041 -19.6267 13.8505 -17.9411 +316 1 14.6429 14.6942 0.394535 -7.00543 -1.89626 8.24203 +317 2 15.0463 15.2494 1.09531 -2.64327 -9.316 -7.76003 +318 2 13.8679 14.2346 0.794348 15.878 11.3494 -8.58286 +319 1 3.51953 11.0524 9.63262 1.11689 7.20138 -8.56155 +320 2 3.49309 11.4422 10.5196 2.01858 0.130954 -3.30783 +321 2 3.17116 11.7397 9.0203 2.67149 -7.88535 6.47818 +322 1 11.039 10.8616 1.27104 8.39953 16.0658 -8.46941 +323 2 11.1885 11.6907 0.750788 0.782166 -19.893 14.3131 +324 2 10.1072 10.6419 1.14889 -0.773464 -1.49716 1.06219 +325 1 13.2204 7.07184 12.8933 -24.0174 5.01566 -6.09093 +326 2 14.1394 6.83939 12.9167 20.0602 -3.76028 0.39046 +327 2 12.7464 6.22555 12.8749 2.49778 2.97258 -0.29329 +328 1 9.62856 1.88969 0.946546 9.2636 -0.931103 20.1878 +329 2 8.76541 2.02695 0.593353 -22.3319 -0.80038 -4.92587 +330 2 10.1675 1.74594 0.181071 13.2226 0.132969 -11.6901 +331 1 10.5934 13.5316 4.73807 16.1446 0.574492 13.3086 +332 2 11.4317 13.0614 4.94174 -10.7106 3.3069 -14.0299 +333 2 10.5321 14.1207 5.51129 -4.24994 -4.20037 -10.3127 +334 1 14.2715 1.70318 10.8964 -1.77809 5.91235 7.28652 +335 2 15.0728 1.25501 10.5853 5.24738 9.35157 -1.74174 +336 2 14.4034 2.67095 10.8772 7.32957 -6.49183 -2.39775 +337 1 14.6603 12.4192 11.7243 1.91159 -25.2344 -56.6412 +338 2 15.4845 12.4874 11.1931 -4.23005 7.1619 22.5795 +339 2 14.0903 12.0081 11.0211 -1.48986 11.1607 31.5891 +340 1 8.24886 5.08654 9.79134 -29.2123 3.64284 23.7692 +341 2 7.42109 5.02927 10.3149 15.0309 17.1198 -4.03621 +342 2 8.23121 4.21184 9.43797 12.1669 -22.8524 -17.3047 +343 1 1.59528 16.8201 18.3251 -4.66834 32.7155 -7.23976 +344 2 1.93304 17.2062 17.488 -5.12416 -8.69561 13.5025 +345 2 1.82608 15.9028 18.3034 8.21551 -19.1337 -3.40609 +346 1 1.44054 17.2474 15.3375 38.2305 -7.16391 -6.50211 +347 2 1.35107 18.1379 15.6308 4.79859 24.8425 9.12518 +348 2 0.562777 16.9452 15.3387 -39.5261 -18.284 -3.02502 +349 1 3.72855 5.57524 6.20331 -9.94128 10.6794 2.05156 +350 2 3.21297 6.20603 6.76334 9.83918 -6.42931 -13.7589 +351 2 4.29894 6.06824 5.5848 -3.89827 7.08279 4.15512 +352 1 12.3545 9.42683 14.1827 20.4014 -41.9092 8.4814 +353 2 12.8623 8.59837 13.88 -21.4785 35.8512 3.66034 +354 2 12.0611 9.1345 15.077 2.36507 11.6403 -12.9904 +355 1 4.03327 15.2744 6.905 24.5442 3.45717 -5.69457 +356 2 3.46314 16.0225 6.67296 5.01039 2.15408 -3.12402 +357 2 4.97164 15.5268 6.67147 -27.9532 -4.4537 7.17357 +358 1 0.606997 8.56433 14.8637 1.00605 -0.185347 4.59471 +359 2 0.51054 9.52697 15.0006 4.18475 -5.95105 -3.81642 +360 2 1.25745 8.45601 14.1476 -5.10421 5.72757 5.73964 +361 1 12.9756 8.36618 10.3398 20.3701 -17.1189 -10.5242 +362 2 13.727 7.8435 10.0036 -6.14808 8.99881 -11.6124 +363 2 12.9675 8.02293 11.2263 -11.3517 2.56625 21.5008 +364 1 15.2884 7.63693 3.49378 10.1588 18.7913 -12.1111 +365 2 14.5458 7.1482 3.08376 7.93209 -0.245397 21.6039 +366 2 15.5211 7.50792 4.43838 -15.1505 -14.5868 -6.72816 +367 1 17.3202 6.64717 0.0328861 -29.9623 13.6257 -2.83905 +368 2 16.7745 5.97673 0.482414 9.93705 -0.647346 -3.81794 +369 2 16.6178 7.22121 18.2734 18.8696 -9.84661 9.86066 +370 1 8.80495 6.92785 7.84504 -31.0915 -18.6038 9.28479 +371 2 9.6769 7.2872 7.80779 30.3288 7.87046 2.96903 +372 2 8.72406 6.35246 8.64105 6.6093 9.83872 -10.9319 +373 1 12.3211 0.614363 1.17365 13.0662 -3.77868 -0.487657 +374 2 13.0766 0.983141 1.64654 -0.239842 1.32967 3.5541 +375 2 12.751 18.5673 0.657414 -10.2946 0.778432 -2.83622 +376 1 5.67951 15.1028 14.5131 10.9467 16.6442 -3.65569 +377 2 4.71936 15.1727 14.6088 -3.18386 3.297 0.861488 +378 2 6.03308 15.9436 14.1233 -11.409 -15.106 9.73801 +379 1 3.83531 6.52602 1.68735 -5.34791 11.2881 1.09554 +380 2 3.46655 7.33088 1.27913 5.03876 -12.3281 -3.02901 +381 2 3.83759 6.80671 2.60341 5.67562 -6.55284 8.9174 +382 1 3.89065 11.6139 12.2421 9.17745 -10.34 -2.42323 +383 2 4.7546 12.041 12.3761 -4.43478 1.7756 4.32079 +384 2 3.22616 12.1252 12.7041 -4.55935 10.4369 8.15325 +385 1 5.44913 3.8771 15.872 6.89679 52.3696 13.3559 +386 2 6.00532 3.19945 15.5174 15.3476 -19.3003 -7.67953 +387 2 6.04432 4.69577 15.9682 -27.8341 -34.2187 -5.04159 +388 1 14.46 10.319 4.39654 9.99722 -28.3378 -34.0856 +389 2 14.8446 9.82936 5.13517 -3.65574 0.244774 4.37558 +390 2 14.7053 9.78242 3.56924 -11.9433 24.8074 33.8136 +391 1 7.944 17.2975 9.23787 -28.0002 30.4191 -3.50914 +392 2 7.19679 17.6006 9.79194 10.1387 -11.5361 -1.79961 +393 2 7.93806 17.9436 8.50883 9.12371 -8.84918 -0.989999 +394 1 4.50274 14.4265 3.96251 25.8442 16.5744 44.5421 +395 2 4.82189 15.3364 4.24204 -15.9069 -22.6382 -13.9696 +396 2 4.78076 13.8411 4.72747 -13.1976 12.376 -28.3375 +397 1 14.3227 7.38582 15.7589 14.6846 6.74467 9.8564 +398 2 15.2487 7.24382 15.4614 -20.8339 3.06086 7.28672 +399 2 14.432 7.78597 16.648 -5.3607 -7.66211 -14.83 +400 1 2.87305 18.2228 1.9038 16.9424 31.4889 37.3817 +401 2 2.5254 17.6641 1.24513 -20.0746 -27.9737 -30.7942 +402 2 2.12041 18.5329 2.44243 8.04928 -1.15784 -8.26421 +403 1 7.96513 1.6038 4.534 28.375 12.0389 1.8382 +404 2 7.4881 1.94169 3.78174 -16.4915 0.831655 -6.1583 +405 2 8.81315 2.08427 4.47067 -11.0504 -12.9149 7.37414 +406 1 2.66628 14.1304 17.7551 -36.5802 -20.3813 5.76686 +407 2 1.82799 13.6385 18.0009 26.1666 13.51 -7.41699 +408 2 3.38829 13.5766 18.1016 -3.21353 7.84202 -3.40779 +409 1 0.72398 1.68558 13.861 19.6061 1.62564 -3.20216 +410 2 0.832024 1.51571 14.7895 8.81281 -5.19825 13.648 +411 2 18.448 1.87896 13.7961 -22.7247 6.41229 -8.76432 +412 1 4.5528 18.6039 13.9643 16.282 -5.93943 -10.6264 +413 2 5.43228 18.1791 13.8337 -18.6035 11.3559 2.42201 +414 2 4.30609 18.3878 14.8696 -5.35687 -0.29015 4.72759 +415 1 7.10471 0.475722 18.3652 -9.95344 30.3778 33.8159 +416 2 7.09526 0.10374 17.5021 -2.11792 -9.18089 -28.9852 +417 2 6.24907 0.928295 18.5508 11.5399 -12.8337 -6.73806 +418 1 16.1003 18.4419 14.1295 -36.1288 -26.1963 -8.72431 +419 2 15.3858 17.8107 13.8537 25.0074 20.4613 -2.43664 +420 2 15.9155 18.5409 15.0697 10.6475 8.10349 1.05551 +421 1 10.1087 4.51964 16.2872 -49.6317 2.46368 -20.184 +422 2 10.9899 4.47274 16.5903 35.3659 -6.27505 9.52333 +423 2 9.84839 3.65208 15.9265 12.032 5.89647 9.33422 +424 1 15.84 17.9245 4.41355 -16.3771 8.07859 19.8211 +425 2 16.4973 18.6399 4.5293 -6.75294 -6.64677 -2.2152 +426 2 15.0245 18.216 4.92863 29.2279 -12.5546 -21.8691 +427 1 6.93052 17.3604 13.733 43.7573 11.6301 8.94285 +428 2 7.46287 17.7112 14.5144 -20.3873 -12.0805 -21.5216 +429 2 7.61723 17.2481 13.0216 -16.2109 2.19972 16.1164 +430 1 13.284 6.56612 6.73549 -17.3988 -10.9235 -13.9284 +431 2 14.2147 6.66272 6.66556 31.8926 9.42178 10.838 +432 2 13.0817 6.39483 5.81333 -16.4457 -2.73061 -4.18006 +433 1 7.68008 2.38704 9.18412 -10.173 -8.0052 -21.8631 +434 2 7.24249 2.31281 10.0234 -2.88588 -0.126179 20.3224 +435 2 6.98126 2.1061 8.54708 21.029 6.80491 7.05088 +436 1 15.1532 14.8723 13.6487 -17.4978 4.30428 5.82091 +437 2 15.0143 15.0659 14.5909 6.59258 -1.67926 -7.31154 +438 2 14.3234 15.1254 13.2077 14.4343 -4.04757 1.78875 +439 1 9.30028 8.33456 3.70705 10.2977 -8.98362 5.75949 +440 2 10.1463 8.82212 3.80538 -6.03443 -8.47657 3.00821 +441 2 9.47356 7.38745 3.89392 -0.00834887 14.0135 -2.32863 +442 1 17.6906 13.477 16.4461 19.9282 13.2905 -5.82842 +443 2 16.7369 13.3711 16.3792 -1.87427 5.41308 -4.03884 +444 2 17.9311 14.3351 16.016 -12.453 -14.9372 6.18952 +445 1 5.04349 10.6567 2.59903 16.1191 -13.6813 18.2195 +446 2 5.79495 10.2927 3.12129 -13.5181 3.52014 -12.0414 +447 2 4.57705 11.1773 3.24438 -8.0447 10.2459 5.04269 +448 1 3.70971 8.35842 10.3252 1.44092 -18.6834 3.58878 +449 2 3.85247 9.29033 10.1825 3.16815 17.7869 -8.4001 +450 2 3.85129 8.23256 11.2753 -2.11366 -0.888936 -6.9574 +451 1 16.1019 7.11228 6.32302 5.1556 -18.0856 -12.5793 +452 2 16.7603 7.67894 6.76117 -3.13697 -10.0137 -6.06994 +453 2 16.5199 6.22503 6.17941 -9.70023 19.4355 5.8489 +454 1 15.1873 7.00993 9.1119 -0.598311 32.9952 -33.7165 +455 2 16.0219 7.38603 9.44635 -11.3494 -6.74009 0.758637 +456 2 15.0255 7.54922 8.27157 3.37955 -23.1281 33.9738 +457 1 6.44391 13.1496 12.9059 -4.52757 0.45998 7.29234 +458 2 7.24313 12.6736 13.1625 -0.99472 -4.48021 -2.73775 +459 2 6.29798 13.7908 13.6311 -2.25413 -7.45453 -16.6836 +460 1 12.1229 4.49714 13.069 31.9377 20.6864 19.2416 +461 2 12.2438 4.59516 14.0263 7.18846 6.47209 -3.71556 +462 2 11.355 3.98337 13.0276 -40.2556 -25.9573 -14.351 +463 1 11.341 8.18871 7.85243 -8.78275 4.89867 3.16356 +464 2 12.019 7.65272 7.40248 3.56578 3.50389 11.6767 +465 2 11.6495 8.4222 8.75253 4.0122 -9.00416 -11.7002 +466 1 17.1801 10.777 7.4192 7.36201 -8.80257 6.42916 +467 2 17.8272 10.0453 7.20283 -14.4353 25.3005 -3.23105 +468 2 17.1099 11.4706 6.73084 6.53972 -12.3853 -1.04707 +469 1 5.23123 18.1422 11.0533 -19.2518 -11.1169 -0.556795 +470 2 4.68428 18.0818 11.8689 9.03658 -0.237539 -15.4649 +471 2 4.66385 17.8138 10.3113 13.0077 11.3369 14.9543 +472 1 7.56693 17.6215 1.82415 1.62007 -3.46367 5.28784 +473 2 7.78898 16.8334 1.34681 6.63524 -26.0188 -1.32905 +474 2 7.45125 18.2129 1.09256 -3.64481 20.3372 -5.96154 +475 1 1.86389 12.9287 13.6093 11.2123 10.389 11.461 +476 2 1.60858 12.3493 14.3514 0.368407 5.87334 -8.62616 +477 2 2.19533 13.7617 14.0254 -8.04715 -19.4049 -4.74077 +478 1 9.73211 6.79545 14.8053 -13.3635 29.1677 -1.2594 +479 2 9.95388 5.9401 15.1198 6.74212 -35.5267 16.6171 +480 2 9.99758 6.80472 13.8879 2.87601 5.55808 -10.3757 +481 1 15.2079 4.3816 10.7747 2.87683 -10.6846 -6.34453 +482 2 16.1141 4.09829 10.8354 14.0041 -14.4682 -8.99775 +483 2 15.2413 5.10857 11.3759 -13.982 19.572 13.657 +484 1 11.1943 6.12299 0.161942 7.30858 3.38886 3.78771 +485 2 11.3169 5.17116 0.363074 -11.79 12.5462 -9.55941 +486 2 10.2709 6.35961 18.5708 8.1781 -12.6509 6.67443 +487 1 0.185288 11.3311 15.1365 -30.887 25.32 -22.6423 +488 2 18.3259 11.8316 14.411 15.9364 -20.9841 19.9458 +489 2 18.5436 11.8171 15.9275 6.31494 -1.3813 -2.75882 +490 1 7.07253 9.14554 7.26503 -12.8693 -9.44748 7.54332 +491 2 6.53496 8.39024 7.60511 8.01051 18.2562 -7.56901 +492 2 7.96025 8.78683 7.22728 5.66006 -0.214789 -0.295522 +493 1 18.4466 15.4455 12.3524 0.715601 -5.5542 4.25712 +494 2 0.765537 15.5739 12.2932 -9.35503 -1.07101 -3.81958 +495 2 18.1041 15.6865 11.4834 1.82716 1.84183 -0.0676895 +496 1 16.5728 4.36435 5.2485 -25.4993 -8.29978 29.4912 +497 2 16.6816 3.92322 6.14286 5.98391 16.1522 -30.7717 +498 2 17.375 4.39451 4.72672 17.8313 -3.46111 1.89189 +499 1 17.7791 3.0704 10.7152 16.7916 7.15275 7.98838 +500 2 0.0816242 3.14072 10.966 -13.8603 5.05813 -1.71981 +501 2 17.7027 2.20602 10.3066 -7.17166 -8.4112 -5.21368 +502 1 12.3075 0.0618611 10.1685 -8.15907 17.9474 -0.312818 +503 2 11.3684 0.344551 10.3468 27.9971 -1.27027 -0.956139 +504 2 12.8942 0.865557 10.2681 -22.4015 -23.39 -3.54403 +505 1 10.3613 9.82386 12.3172 12.1455 12.129 19.7304 +506 2 11.1427 9.8808 12.9129 -10.2174 -2.53791 -7.09814 +507 2 10.1997 8.88396 12.252 -0.966331 -12.4705 -0.927319 +508 1 0.481536 2.83002 7.02126 3.70324 23.8076 -10.0458 +509 2 0.770856 3.62826 7.51109 -3.83076 -19.2444 -0.666321 +510 2 0.694466 2.06428 7.55035 5.7415 -3.83046 10.8422 +511 1 0.467049 15.2425 6.91705 -4.45928 -38.0226 -11.2702 +512 2 0.600151 15.6263 7.78281 2.30728 -6.41275 13.0317 +513 2 0.61271 14.2361 7.00049 -2.84554 47.7716 -5.16909 +514 1 16.9541 7.01237 15.3291 23.6374 -7.48971 -3.1828 +515 2 17.7457 7.53254 15.1705 -1.99719 18.034 -6.10418 +516 2 17.38 6.19105 15.5941 -13.3003 -10.4743 0.120416 +517 1 9.01017 12.4224 8.1441 -46.2717 9.6088 -11.1501 +518 2 9.26268 11.8248 7.45061 25.2615 -14.9445 -10.6927 +519 2 8.05034 12.5239 7.91838 26.5695 6.53823 20.3475 +520 1 1.26455 1.94093 3.05316 3.58571 9.71968 -12.011 +521 2 1.22461 2.59742 2.34045 -8.12686 -11.986 1.71554 +522 2 1.93366 2.31359 3.63129 0.35358 -2.72116 4.87465 +523 1 4.13309 15.1146 9.63821 -4.623 1.46382 -0.938733 +524 2 4.12694 15.148 8.67475 -7.89004 5.45838 -0.100118 +525 2 4.98588 14.7259 9.81048 11.3537 -4.87926 10.963 +526 1 7.17766 2.17952 14.5652 7.62536 9.73749 11.0593 +527 2 6.96972 1.69872 13.7643 -0.327528 -0.451328 -7.35604 +528 2 7.66158 2.98182 14.3072 -3.86315 -8.18785 -0.50787 +529 1 18.6094 14.7115 2.1553 18.1066 -29.4746 -3.14947 +530 2 0.852094 15.108 2.23259 -6.38197 3.09186 -0.259441 +531 2 17.9366 15.3527 2.32074 -15.2526 23.2774 3.26778 +532 1 9.94663 2.7868 12.9455 2.69617 -13.1789 -11.1834 +533 2 9.77369 2.19316 12.1903 7.43131 1.21406 6.14773 +534 2 9.20096 3.38667 12.9408 -6.30409 9.38042 4.37845 +535 1 2.80852 8.91644 13.0153 -16.8956 -9.28674 -0.0207487 +536 2 3.13809 9.78934 12.8448 9.36486 20.7895 -4.33486 +537 2 3.52774 8.43066 13.407 13.2058 -10.3846 6.75792 +538 1 3.23128 8.35577 3.63883 6.10249 8.71431 60.2633 +539 2 3.54401 9.08838 3.13137 7.96401 15.5303 -21.3649 +540 2 3.46232 8.64756 4.58519 -13.4978 -19.9669 -35.5279 +541 1 5.63324 7.19832 8.5125 -13.133 -10.0414 6.96154 +542 2 5.51092 6.25688 8.34615 12.8941 -5.44374 -4.51219 +543 2 4.92213 7.36133 9.14092 2.83191 13.4678 4.26874 +544 1 14.878 1.27944 2.0109 -7.35803 -30.2596 -13.1701 +545 2 14.8616 1.98275 2.64555 4.54601 24.3613 2.83628 +546 2 15.264 1.50064 1.14913 0.22226 12.7122 6.62367 +547 1 8.2353 15.1956 0.84899 9.2054 13.6294 -15.3468 +548 2 9.04355 15.0937 1.38227 -7.5254 -5.87742 4.76726 +549 2 7.50355 14.6763 1.20804 4.58246 -4.32042 7.88142 +550 1 15.6328 1.34461 7.23795 -19.9173 -11.1245 -9.46976 +551 2 14.9591 0.718796 6.85982 16.5955 19.1651 8.9454 +552 2 15.1508 2.16575 7.45752 1.02199 -7.71962 -3.30529 +553 1 4.91374 13.0908 18.526 15.2565 -4.60213 14.3208 +554 2 5.33439 13.1154 0.77269 -6.07604 1.59812 -16.6926 +555 2 5.51105 13.5936 17.9543 2.83588 -2.74206 0.160853 +556 1 15.3493 8.4742 18.1502 12.1518 9.73195 -18.1744 +557 2 15.7592 9.1135 17.5088 -10.0207 -13.011 16.7995 +558 2 15.2243 8.95162 0.336167 -0.033387 6.18709 -0.40176 +559 1 12.0721 3.03363 18.372 7.89134 -10.3745 2.1206 +560 2 12.0185 2.56449 0.551271 -8.88822 8.03447 17.3967 +561 2 12.5632 2.36483 17.898 4.02516 4.57474 -24.0136 +562 1 13.2076 12.6757 5.17908 4.47921 -5.37266 1.03993 +563 2 13.7293 11.9632 4.79272 -2.12471 -1.88137 -7.76598 +564 2 13.3867 12.5644 6.11349 -3.52883 8.17381 9.78336 +565 1 6.04737 7.04753 0.0353989 10.049 -23.447 -5.31085 +566 2 6.01346 7.99319 18.6275 -7.37118 27.2698 7.20756 +567 2 5.32085 6.74358 0.593628 -6.10646 3.40609 1.47388 +568 1 17.7373 16.0235 15.0083 12.9173 -11.5355 46.7271 +569 2 16.9426 16.5159 15.2406 -3.68569 -0.0523083 -17.9381 +570 2 17.9142 15.8937 14.0864 -12.7219 4.58342 -31.2732 +571 1 13.1912 1.0014 16.5506 10.6966 -14.1722 10.2872 +572 2 14.1553 0.911674 16.6931 -11.9901 3.10273 -3.01829 +573 2 12.8874 0.074803 16.5753 -2.30324 8.04411 -4.14072 +574 1 11.1133 14.5665 7.20897 13.0955 23.3619 -16.6223 +575 2 10.3963 14.2935 7.74934 -21.4591 -15.3449 18.7975 +576 2 11.8402 13.9563 7.34501 4.8973 -5.05394 6.63835 +577 1 17.5096 8.63113 2.08657 0.966478 12.3426 12.6691 +578 2 16.6632 8.50317 2.50987 -10.5053 2.55961 10.3047 +579 2 17.5113 7.91267 1.47949 7.23292 -21.4893 -25.4513 +580 1 12.353 7.99884 2.01581 -2.70101 10.6364 -12.6504 +581 2 12.1945 8.88312 1.63494 1.68617 -6.44935 12.5501 +582 2 11.9639 7.41552 1.35659 -1.58766 -9.18843 -2.08326 +583 1 11.8879 14.6194 10.3406 -20.0746 -33.6598 -22.8547 +584 2 12.0361 13.784 9.8263 4.17148 28.2224 18.5196 +585 2 10.9018 14.6878 10.3309 21.6541 8.7111 3.83339 +586 1 6.88836 7.04362 15.6058 16.1194 20.5136 16.4981 +587 2 7.8035 7.27617 15.3369 -14.4637 -10.2261 -3.41305 +588 2 6.75267 7.59066 16.4113 -4.12685 -13.7627 -18.0291 +589 1 8.00073 4.72844 13.473 32.6072 13.4681 12.0072 +590 2 7.24466 4.78195 12.9199 -26.1194 -0.34176 -19.7698 +591 2 8.43099 5.60279 13.3668 -6.56701 -17.694 4.3215 +592 1 13.409 12.181 14.2619 -2.29334 -12.519 -3.59046 +593 2 13.0674 11.2691 14.1939 2.47622 3.528 5.79283 +594 2 13.8091 12.3245 13.3914 2.14013 7.29019 1.49174 +595 1 14.8335 9.42126 7.30208 -1.23415 -9.7028 -7.755 +596 2 15.6553 9.87909 7.43544 15.0677 5.06613 0.278043 +597 2 14.1895 10.0298 7.62302 -19.0881 6.3544 7.09879 +598 1 12.6523 17.0615 3.07749 -9.63712 20.8437 4.73829 +599 2 12.9489 17.4748 3.92954 -9.59054 -7.90452 -22.4084 +600 2 12.0211 17.6908 2.6147 24.5964 -20.1603 22.3384 +601 1 1.16316 7.14216 17.4575 -7.53687 9.98877 -12.7143 +602 2 0.304551 7.18474 17.9202 3.89796 -5.88799 -6.19513 +603 2 1.03245 7.53978 16.5617 1.30151 -5.77621 16.2427 +604 1 12.7701 5.15004 15.6505 19.6392 -10.8067 9.95473 +605 2 13.4563 4.50157 15.9538 -13.2351 19.2956 -11.0391 +606 2 13.2014 6.03319 15.6187 -0.0564141 -13.897 1.41482 +607 1 2.5292 3.39223 4.98971 -11.294 24.8894 43.5462 +608 2 1.79321 3.13497 5.63732 25.431 9.26734 -19.6171 +609 2 2.95221 4.24201 5.36402 -18.0427 -37.3772 -14.0443 +610 1 8.3195 11.2975 13.4498 34.4282 -42.0873 60.0692 +611 2 8.53145 10.9623 14.3727 -32.5783 27.093 -24.5589 +612 2 9.06913 10.8398 13.0623 -1.46455 6.72769 -32.5395 +613 1 12.8789 1.33599 13.3369 -0.326833 21.0111 -2.4484 +614 2 13.4114 1.42549 12.5087 -12.3149 4.19021 14.3531 +615 2 12.3728 2.16885 13.5095 17.1543 -18.8215 -15.124 +616 1 6.3438 13.6989 2.14861 -9.76603 2.4566 0.239062 +617 2 5.66699 13.9965 2.80165 17.5467 -9.19207 -8.6938 +618 2 6.94024 13.0708 2.57673 -0.273551 -0.649347 7.27334 +619 1 15.9211 6.60722 12.7931 -16.6599 -18.553 -4.38331 +620 2 16.3967 7.19214 12.2261 12.0088 12.5524 -15.4249 +621 2 16.3823 6.6241 13.6257 5.92705 1.19016 14.7721 +622 1 16.8355 0.712467 9.59592 -3.36362 -23.3789 -3.56206 +623 2 16.7779 18.376 9.75078 1.74957 20.9638 -0.413143 +624 2 16.4581 0.840534 8.70411 1.17104 2.38037 5.50581 +625 1 6.14488 11.7511 8.38011 -0.18946 -41.167 -3.37934 +626 2 5.27459 11.5011 8.78729 18.3987 2.85732 -10.3128 +627 2 6.60987 10.8879 8.11154 -22.1828 30.5528 10.1053 +628 1 2.89693 8.62105 0.44295 -56.4203 1.00956 -31.5069 +629 2 2.27197 8.22062 18.4324 34.822 -7.67477 5.45833 +630 2 2.23776 9.23156 0.789096 17.398 15.3469 20.296 +631 1 10.1637 10.4615 6.50349 -4.04384 3.34709 -8.13679 +632 2 10.5967 9.72069 6.94847 1.64295 -0.870339 0.249421 +633 2 10.4974 10.4621 5.5852 -1.057 -0.999308 12.8758 +634 1 6.73224 15.6973 6.55436 -2.09809 -5.48823 4.73835 +635 2 7.11043 16.1412 7.33204 2.41282 1.16671 -8.98558 +636 2 7.01002 16.1566 5.74315 2.18916 7.51026 7.17736 +637 1 6.44608 13.1679 5.58195 -4.20705 -14.9444 9.79279 +638 2 6.65412 13.9682 6.06813 3.08652 7.67851 0.170606 +639 2 6.07667 12.5708 6.24938 0.761343 1.39557 -4.00611 +640 1 16.8208 12.5604 9.84104 -2.42329 -13.6856 -22.0974 +641 2 16.9708 11.9197 9.11347 0.32984 0.887075 14.5477 +642 2 16.637 13.3652 9.35916 0.987515 11.3295 4.43609 +643 1 6.04174 2.95051 2.84722 -0.719082 -29.0389 17.5165 +644 2 6.39757 3.79665 2.63265 6.28437 26.7212 -14.5644 +645 2 5.5959 2.56013 2.08759 -0.264068 2.45464 -11.4985 +646 1 10.912 3.32579 3.30021 -11.54 -3.72468 -0.286686 +647 2 10.265 3.99241 3.57025 6.99069 0.708994 3.18227 +648 2 10.4899 2.90229 2.54711 3.22659 -3.75767 -5.68185 +ITEM: TIMESTEP +20 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.70913 7.06604 17.9499 1.08039 -7.3052 -10.6944 +2 2 7.76309 6.93671 18.0927 2.86377 -0.0634365 6.14939 +3 2 8.89082 6.62218 17.113 -0.435012 1.17195 3.96762 +4 1 18.5701 8.27154 6.84569 7.63886 -4.25596 16.0618 +5 2 0.0770478 8.01704 5.94511 2.80666 -2.10014 -27.175 +6 2 0.448594 7.6266 7.34851 -2.05713 5.96795 6.45131 +7 1 8.39922 18.5714 6.82203 6.72948 10.2859 -1.45868 +8 2 9.32775 0.155905 6.65662 -6.00666 -1.87083 0.283604 +9 2 7.88802 0.6421 6.41318 2.19693 -3.22314 0.641978 +10 1 6.59462 1.83749 11.6886 4.57701 1.91935 4.50468 +11 2 5.92153 2.26167 12.2253 -5.29818 6.79114 -2.36061 +12 2 6.2022 0.990271 11.4833 -4.39091 -13.1588 -5.35683 +13 1 7.12455 5.7334 2.35273 -30.6289 32.8622 11.4294 +14 2 6.61502 6.28908 3.00258 14.1285 -25.9969 -7.59408 +15 2 6.93422 6.24286 1.54682 10.1555 -14.3812 -3.81516 +16 1 16.2065 10.1646 16.1262 8.40668 11.1152 -6.07805 +17 2 17.0895 10.2474 15.7446 -2.7739 -5.15617 3.84543 +18 2 15.9438 11.0841 16.2665 -7.12418 -3.1551 3.11568 +19 1 10.6155 14.9936 2.32061 -1.92123 -0.42827 -4.10202 +20 2 10.587 14.5409 3.17342 -1.90113 -4.17135 2.45193 +21 2 11.1106 15.7965 2.49753 3.42935 4.58062 3.08668 +22 1 17.1538 8.25609 10.4362 5.05968 0.945942 4.2849 +23 2 16.7065 8.97876 10.9029 -1.41924 -5.56537 3.25582 +24 2 18.0123 8.61559 10.168 -2.45464 0.72557 0.389593 +25 1 14.8661 15.8683 16.3562 3.75833 -10.1031 -0.407994 +26 2 13.9609 16.1531 16.2809 -17.2441 8.84265 -1.93831 +27 2 14.8525 15.2671 17.1114 5.79928 3.60638 8.20478 +28 1 12.159 13.3907 0.439783 -6.21112 9.36015 -5.49833 +29 2 12.0312 13.5738 18.1447 5.07318 -6.56614 -2.93527 +30 2 11.6434 14.08 0.875998 -3.18612 -5.19303 11.2101 +31 1 9.2695 5.40921 4.0396 -15.9764 -20.2303 6.13461 +32 2 8.8083 5.02157 4.82949 8.30048 18.0685 -17.5094 +33 2 8.61456 5.30675 3.30783 11.5288 9.4755 11.0493 +34 1 1.82939 4.25621 11.6493 -6.71206 2.38393 -0.709376 +35 2 1.74358 5.20905 11.8686 0.595776 -11.527 -1.23597 +36 2 2.30823 3.82152 12.3665 0.967745 0.8605 0.134832 +37 1 1.98223 6.83069 8.36497 -5.35455 0.0641687 -19.1444 +38 2 2.41924 7.2303 9.11786 5.68758 -2.51321 7.89524 +39 2 2.03012 5.87061 8.47368 0.241822 -0.370612 9.81388 +40 1 5.39801 4.40718 7.93771 10.9733 2.82986 12.12 +41 2 5.47637 3.44759 8.05616 -6.09239 2.90192 -10.948 +42 2 4.7514 4.61131 7.25273 -1.49389 -3.85519 0.176314 +43 1 3.26825 2.92232 17.539 -14.9988 14.8633 6.4114 +44 2 3.91862 3.43305 17.0175 -2.74895 -4.28964 2.11315 +45 2 2.69145 3.57031 18.023 20.6758 -7.505 -11.8237 +46 1 7.47034 5.2735 6.10589 -2.49502 5.37071 -3.04547 +47 2 7.84271 5.98269 6.68437 -5.78386 -20.7203 -0.884416 +48 2 6.94663 4.6123 6.60405 7.6241 17.9385 5.03136 +49 1 9.77266 7.01281 11.9821 10.4665 -1.38292 10.7277 +50 2 10.3585 6.42202 11.517 6.59042 -6.6592 -2.49871 +51 2 9.12807 7.25863 11.3259 -16.7919 6.8996 -8.63143 +52 1 14.096 3.56038 8.06303 -5.03459 -1.11151 -11.1946 +53 2 13.7156 4.24767 7.5046 0.899669 0.845681 1.92473 +54 2 14.4812 4.01512 8.80943 2.7486 3.89851 9.64387 +55 1 4.73966 17.2567 4.00996 -0.195125 14.326 -18.5317 +56 2 5.55163 17.7707 4.1353 -4.1295 -8.09403 5.71009 +57 2 4.38972 17.5915 3.15482 -7.00181 -7.87351 15.3992 +58 1 16.5025 16.6092 10.0733 13.1432 9.20378 8.07617 +59 2 15.9712 16.6856 10.8668 -9.96451 -5.5735 1.54085 +60 2 15.9848 16.1464 9.41138 -7.70063 -5.20479 -0.44901 +61 1 1.97052 4.91045 0.450899 1.06366 9.69844 4.9192 +62 2 2.61093 5.33981 1.06219 -5.49885 -10.5105 -8.09306 +63 2 1.57388 5.6737 18.6422 7.70456 -7.85061 -0.972244 +64 1 11.7662 13.3441 16.2815 -7.88535 5.38496 10.7421 +65 2 11.2704 12.5109 16.442 6.50023 4.10664 -10.6094 +66 2 12.3479 13.2575 15.5066 -9.92493 -12.14 1.82083 +67 1 10.1201 11.0576 16.9389 3.39974 -19.6625 0.923124 +68 2 10.5319 10.1651 17.0061 -5.17122 15.3709 -2.15755 +69 2 9.17725 10.8754 16.8052 5.13113 2.71984 -2.06215 +70 1 11.7111 17.5152 13.4588 11.325 -2.75861 -1.19784 +71 2 12.3718 17.1152 12.8813 -0.632983 -4.36671 1.26506 +72 2 11.9961 18.4406 13.4806 -4.40298 2.90056 2.38202 +73 1 6.35795 9.30394 12.2283 8.95317 6.42027 -9.35456 +74 2 6.91663 9.09838 11.465 -5.59359 -11.5346 -0.139091 +75 2 6.8458 10.0391 12.6013 -0.320164 5.49925 11.3434 +76 1 16.2195 12.7457 2.69542 0.295574 -29.3957 1.13627 +77 2 17.0216 13.1501 2.38091 9.97003 13.3951 -1.47132 +78 2 15.5842 13.4209 2.91145 -9.8096 20.1499 -2.69183 +79 1 0.634077 12.5728 5.88372 -7.9484 2.86768 -4.89493 +80 2 0.988616 12.3569 5.00851 -6.1101 5.76055 1.83916 +81 2 18.334 12.7959 5.71409 15.811 -6.64636 4.43625 +82 1 5.2077 16.407 18.4749 -9.68849 -0.552221 -6.28119 +83 2 5.84718 15.7794 18.0984 2.41425 5.32286 5.94338 +84 2 5.56586 16.8292 0.618687 8.26881 -4.78153 -1.34873 +85 1 0.531249 7.63213 4.08542 33.6963 23.9515 -16.2824 +86 2 18.6021 7.94352 3.35108 5.75308 0.311196 11.7347 +87 2 1.44781 8.03396 3.8909 -38.1012 -20.2476 4.98268 +88 1 3.13519 8.90219 6.5128 -18.1806 -1.10975 19.7922 +89 2 3.61721 8.66647 7.3217 -0.167991 0.711605 -10.7948 +90 2 2.18954 8.88363 6.78472 17.5501 0.713198 -9.35234 +91 1 7.30642 10.3086 16.1993 0.33826 1.86993 11.5423 +92 2 6.5825 10.5097 15.5962 -1.40069 -1.74837 7.12047 +93 2 6.94436 10.2588 17.1142 -3.68695 0.804433 -15.344 +94 1 11.1033 1.05136 4.99998 6.51415 -6.68887 15.4104 +95 2 11.3804 1.86173 4.55399 -8.93638 -1.72916 -9.27788 +96 2 10.7652 0.40817 4.35737 0.804793 8.53975 -5.36269 +97 1 4.41906 2.71829 13.1993 1.75265 -17.8891 31.6776 +98 2 4.61925 3.15892 14.0364 2.0928 12.2335 -7.50334 +99 2 4.34595 1.79439 13.5397 -3.31279 7.49147 -22.0731 +100 1 8.39429 10.0534 1.8011 7.989 6.96853 5.58503 +101 2 8.43083 10.7556 2.48299 -4.47719 -6.35615 -3.34103 +102 2 8.76263 9.25633 2.22388 -6.49712 6.95404 -2.63041 +103 1 10.5097 1.74962 15.5619 -18.3761 -0.922722 7.55335 +104 2 11.4225 1.47346 15.6803 4.80494 4.8298 -6.32182 +105 2 10.3374 2.00269 14.6445 6.81104 -1.01801 -3.49857 +106 1 2.7507 12.9226 7.76103 -0.99391 -3.54814 -5.35437 +107 2 3.2837 13.6196 7.35675 1.026 0.47841 4.16479 +108 2 2.1823 12.6261 7.03948 -5.64928 1.37633 4.69044 +109 1 3.65655 11.6901 5.29539 -1.74666 1.04695 -5.47464 +110 2 3.42979 10.9863 5.91968 -0.390133 2.11749 -7.53732 +111 2 2.90341 11.8434 4.69867 6.59799 -3.91283 3.78854 +112 1 6.86195 14.4839 16.8677 -6.59977 -5.37582 9.26387 +113 2 7.63594 13.9204 16.7929 -0.0312736 1.63672 -3.94334 +114 2 6.43125 14.5303 16.0039 6.73415 3.59122 -3.18668 +115 1 14.1795 14.5536 3.39757 15.4782 -5.44823 -10.5 +116 2 13.7027 15.3725 3.25557 -8.02005 3.41109 -0.200737 +117 2 13.6761 13.9828 3.97966 -5.46722 0.130817 9.75683 +118 1 8.30625 18.1704 16.0558 -18.3501 -5.93921 0.16691 +119 2 8.73243 17.3486 16.3757 13.662 16.7968 -4.53324 +120 2 8.86048 0.311637 15.8745 11.2379 -14.2941 4.19403 +121 1 4.7262 1.6175 4.92485 1.6266 19.4211 -17.3379 +122 2 3.85517 2.05812 4.84475 13.0303 -7.24689 7.72044 +123 2 5.31448 2.15314 4.34837 -14.7695 -11.1634 6.67198 +124 1 15.0789 12.7964 16.4332 -6.30353 8.33681 17.3183 +125 2 14.5699 13.1854 17.1557 10.6035 -4.81202 8.18161 +126 2 14.431 12.7912 15.7403 -5.45963 -10.7064 -24.7799 +127 1 15.7876 18.4014 16.8102 7.97993 -1.6905 34.0366 +128 2 16.3475 18.509 17.631 -13.1355 2.97046 -27.3317 +129 2 15.4303 17.5059 16.9211 5.07282 4.66478 -9.26997 +130 1 1.15379 1.15776 16.5585 8.66192 -1.89028 -5.04545 +131 2 1.90132 1.75074 16.7615 -7.4852 -3.92147 5.78546 +132 2 0.484053 1.2881 17.242 6.61018 5.41271 -0.381602 +133 1 18.0958 4.56873 15.8951 8.25715 -8.22974 -2.59939 +134 2 18.5403 4.03662 15.2192 -4.31028 2.25805 3.56674 +135 2 18.6753 4.5681 16.6654 -3.11748 0.528024 -3.18079 +136 1 12.2229 16.9717 16.1366 4.99185 -14.9968 15.1993 +137 2 11.5697 16.3784 16.5746 6.13992 18.0067 -10.7689 +138 2 12.0903 16.9196 15.1862 -11.661 1.79059 -6.40221 +139 1 15.9175 2.52925 17.9868 -5.04918 24.4496 -1.91719 +140 2 15.7053 3.35036 18.4645 1.43445 -9.55155 0.206063 +141 2 15.6037 2.74854 17.0829 8.19816 -13.208 8.21894 +142 1 6.7035 13.812 10.2396 3.19471 14.7437 0.534165 +143 2 6.61208 13.6203 11.1841 -1.85117 -10.3739 -2.65392 +144 2 6.65674 12.9942 9.7292 -2.15383 -4.24588 3.01674 +145 1 10.13 18.2471 2.79005 6.2323 7.4499 -7.90816 +146 2 10.2641 0.289717 2.1086 -4.88175 -4.44055 6.63338 +147 2 9.27512 17.8471 2.59242 -0.00557908 4.28296 0.85488 +148 1 2.97726 17.7544 6.09154 9.3411 -8.798 -12.7807 +149 2 2.21419 17.6669 5.51339 -17.57 2.09099 8.77855 +150 2 3.67394 17.6484 5.43984 9.00485 8.25893 -0.00709571 +151 1 12.565 16.9537 7.99058 7.14198 1.79921 -4.31208 +152 2 11.8238 16.3251 7.88339 1.67036 10.005 4.65414 +153 2 12.3624 17.6704 8.62526 -6.57036 -14.6618 3.16709 +154 1 14.8823 15.2807 8.26789 -1.91265 -14.526 28.7428 +155 2 14.153 15.9118 8.23916 -2.47753 6.09246 -10.9919 +156 2 15.4304 15.3156 7.48892 0.613021 10.1448 -23.5664 +157 1 17.5919 18.2849 0.376053 -34.2379 -2.64943 -3.08159 +158 2 18.3697 17.8673 0.0312256 25.6277 -7.0964 -1.13253 +159 2 17.798 0.454484 0.829223 12.3697 7.05842 3.85092 +160 1 0.890355 10.3869 1.40531 11.5261 -26.8893 18.421 +161 2 0.106732 9.81739 1.52594 3.68606 12.403 0.666184 +162 2 0.670163 11.0869 0.811123 -14.943 21.2909 -16.3167 +163 1 1.59243 12.2061 3.32787 10.8868 -1.98125 32.4665 +164 2 1.41581 11.4302 2.79423 -4.35317 -0.696655 -17.6875 +165 2 1.68603 12.9921 2.7891 -2.29445 2.46974 -13.9165 +166 1 0.556424 17.2525 4.88159 28.516 -3.31441 -27.2608 +167 2 -0.112492 17.9263 4.93691 -11.7284 7.93843 13.1539 +168 2 0.513874 16.5834 5.55808 -11.2757 -6.6263 16.6148 +169 1 1.11617 0.979823 9.41029 -8.01472 5.90786 -6.49609 +170 2 1.17088 0.754182 10.3385 12.3333 -8.44182 10.8127 +171 2 0.193916 0.78552 9.22994 -1.98368 -3.92324 -6.63209 +172 1 16.7786 2.33534 13.2836 0.301257 -1.02782 -8.61363 +173 2 16.9098 2.55877 12.34 -0.551981 -1.96326 12.3514 +174 2 16.5533 1.39033 13.3371 -1.81134 4.54396 -2.66642 +175 1 2.50838 15.8231 12.1881 11.0759 -0.61625 -4.91684 +176 2 3.05623 15.4799 12.9137 -5.11001 1.87196 -7.11666 +177 2 2.97562 15.6336 11.349 -1.75425 -0.738878 7.05871 +178 1 16.4241 15.5762 5.95419 20.8818 34.7414 3.73321 +179 2 17.3417 15.6388 6.29893 -10.1511 -9.39035 -1.02331 +180 2 16.3256 16.4387 5.46724 -6.92566 -23.7939 4.29358 +181 1 5.82318 5.04015 11.787 7.38202 -1.28642 -1.97288 +182 2 5.53279 5.76584 12.3478 -8.19426 6.74642 1.34004 +183 2 5.25308 4.28957 11.9879 -3.19521 -0.0404241 -0.10221 +184 1 15.2058 4.86095 0.714988 -15.0911 -0.578133 32.6943 +185 2 15.0554 4.65905 1.68214 1.80466 1.09263 -27.7183 +186 2 14.3514 5.22673 19.0716 10.184 -3.76227 -2.57358 +187 1 16.3414 16.3313 2.1188 1.69452 -20.4231 -15.1031 +188 2 15.9696 16.7397 2.89766 0.772445 11.9995 9.83785 +189 2 16.487 17.0139 1.46036 1.64169 8.90638 2.00624 +190 1 0.27953 4.87193 3.80304 22.0083 21.7264 1.42732 +191 2 0.488965 5.84197 3.75834 -13.581 -23.7134 5.51739 +192 2 1.12962 4.47493 4.05501 -10.8528 -1.93786 -0.672788 +193 1 2.93644 15.0118 15.0505 -0.31189 -6.67479 38.4938 +194 2 2.77152 14.5973 15.941 9.17422 6.49202 -18.5047 +195 2 2.6087 15.9081 15.2082 -8.55577 3.59906 -10.383 +196 1 1.11893 14.5977 9.54871 15.5404 -15.1461 3.70851 +197 2 2.05973 14.499 9.39244 4.56619 15.8955 -5.72674 +198 2 0.980037 13.7309 9.94382 -18.1835 3.0763 3.0761 +199 1 13.6623 16.6444 11.5318 -24.61 2.13122 1.95847 +200 2 13.1623 17.4223 11.2076 12.7863 -8.68657 -5.97173 +201 2 13.1098 15.8918 11.2458 9.29846 2.29742 -4.43006 +202 1 4.71401 1.48013 0.724257 -0.188744 -1.90188 8.47653 +203 2 4.10877 2.04213 0.209428 1.54459 -7.39683 1.44825 +204 2 4.1847 0.878426 1.28084 -4.13807 4.124 -10.8706 +205 1 1.4317 18.499 11.8861 -0.747589 2.74228 -9.05649 +206 2 1.26248 0.376362 12.6752 -1.22453 3.10674 7.57799 +207 2 1.76508 17.6414 12.1696 1.67944 -1.01146 1.59049 +208 1 11.5426 10.114 4.08871 14.5973 5.39555 -25.8673 +209 2 11.3947 10.5181 3.18641 4.0612 -8.18021 22.6028 +210 2 12.5241 10.0302 4.19261 -20.6338 4.9276 -1.52234 +211 1 8.35442 12.1679 3.75067 -15.8416 -4.27069 -7.38356 +212 2 9.18656 12.6319 3.95442 -10.6107 -0.215004 12.2135 +213 2 7.67679 12.3128 4.45645 22.0699 3.83678 -6.48541 +214 1 14.3334 4.02625 3.28975 21.4077 6.9275 8.44763 +215 2 15.0849 4.22802 3.89908 -16.2072 -5.96795 -3.3621 +216 2 13.5509 4.49592 3.62574 4.82101 -0.669553 -3.42678 +217 1 5.57933 1.73516 7.50739 -24.0378 -31.7376 11.0088 +218 2 4.91074 1.07012 7.91595 32.7583 31.1537 -18.2093 +219 2 5.45045 1.65908 6.53973 -4.97377 0.997246 11.1506 +220 1 17.8945 1.1186 4.8831 -1.36037 -2.43827 -6.93143 +221 2 18.5804 1.42855 4.26031 -6.60553 2.78724 7.64102 +222 2 17.8025 1.76232 5.59874 4.87877 0.216211 -3.29328 +223 1 6.83024 9.40422 4.48506 -14.9488 0.581331 -12.2421 +224 2 6.75886 9.5424 5.43046 9.61942 2.86103 10.3107 +225 2 7.75214 9.21615 4.27366 4.86133 -4.03573 4.34319 +226 1 2.68867 14.9529 1.96243 -3.68441 -0.0776758 1.15821 +227 2 3.24659 14.6776 2.70632 3.58292 1.9147 -7.42106 +228 2 3.21497 14.9558 1.15083 1.81588 -2.88288 8.16929 +229 1 17.2949 12.8929 13.1574 -7.5849 14.4302 -4.04848 +230 2 16.4401 13.3055 13.2858 -13.783 -13.5119 9.83474 +231 2 17.7157 13.6748 12.8001 24.9453 0.592093 -1.55303 +232 1 15.0095 10.5719 1.38917 -11.2702 -15.2105 -5.46509 +233 2 15.5687 11.2426 1.76309 11.9887 12.322 8.95719 +234 2 14.2298 11.0424 1.10476 -6.47688 3.25886 -0.810136 +235 1 5.70264 6.91192 4.53101 4.96234 -7.94583 8.40724 +236 2 5.98573 7.83684 4.52277 1.36545 -0.678753 -1.4492 +237 2 6.33051 6.43499 5.10591 -2.47306 1.6182 -5.79546 +238 1 8.0801 8.26782 10.1943 -2.48094 -3.5573 30.8197 +239 2 8.76371 8.85191 9.85613 0.308879 9.43682 -13.0265 +240 2 7.56027 7.88877 9.48994 -2.62488 -0.283604 -15.3664 +241 1 13.5 18.3149 5.7974 -5.02979 10.2931 3.81039 +242 2 12.85 0.37996 5.63415 -2.0272 -10.2183 1.79381 +243 2 13.182 17.8392 6.59435 1.6098 2.02728 -12.9685 +244 1 0.276709 2.57627 0.11216 -0.0492842 3.76989 10.2262 +245 2 17.9528 2.7291 18.6895 13.0336 8.33648 -1.41355 +246 2 0.811706 3.36861 0.368499 -21.4808 -7.42382 -6.02819 +247 1 12.6714 10.9997 9.76016 -23.5437 -7.71308 -4.31472 +248 2 11.7133 10.8659 9.59681 15.3229 11.3368 0.532821 +249 2 12.914 10.0869 9.9422 13.3726 -3.72203 6.47581 +250 1 0.779958 12.2601 11.0819 -4.3547 -6.1438 5.62044 +251 2 18.4678 12.2984 11.1653 -6.51403 -1.20026 -7.70008 +252 2 1.07438 12.4529 11.9792 8.34734 4.57522 -3.24255 +253 1 5.0586 7.24501 13.467 -14.0099 -7.28532 -8.10759 +254 2 5.49528 8.03405 13.1289 12.6282 1.90126 -2.15469 +255 2 5.51501 6.98287 14.2704 7.34444 5.85192 6.7727 +256 1 1.26105 6.94281 11.8301 -2.26861 -4.26975 2.97 +257 2 0.502637 7.2894 11.3564 -2.98104 -0.152382 -1.57853 +258 2 1.67901 7.71469 12.2201 5.00338 4.10874 -3.32488 +259 1 15.4732 9.48624 12.3091 -7.90575 31.4836 20.4854 +260 2 15.2888 10.4503 12.3878 3.68649 -17.5592 -11.9783 +261 2 15.3484 9.17907 13.2194 3.56004 -6.14635 -9.9625 +262 1 16.6235 12.9071 5.45115 4.22183 -17.5767 13.0612 +263 2 16.4576 13.8585 5.58703 -5.89626 -6.38642 -16.4082 +264 2 16.4453 12.6107 4.54016 -1.61972 14.741 3.30454 +265 1 6.17978 10.0207 0.140312 6.69901 -0.902574 1.02107 +266 2 5.53175 10.4562 0.704359 -7.04498 -0.0752206 -3.29626 +267 2 6.99223 10.1412 0.643131 5.59964 -6.49227 2.85612 +268 1 12.3558 6.06094 4.04059 -1.82306 -10.4932 18.2897 +269 2 12.2948 6.89378 3.5711 -3.30175 6.87328 -14.7087 +270 2 11.4523 5.72881 4.15047 2.03572 4.51633 -5.92335 +271 1 0.151611 12.8143 0.201399 6.45324 -5.46068 -3.81056 +272 2 -0.0140355 13.4798 0.883392 3.4035 3.37155 -1.9342 +273 2 18.3672 13.1447 18.0414 -1.87626 -1.08321 2.97259 +274 1 3.81145 18.5877 8.5912 1.31461 -3.73146 5.16785 +275 2 3.56882 18.0432 7.82418 -6.49798 6.54364 1.53441 +276 2 2.99788 0.372962 8.89657 -5.11276 -3.31294 -4.1744 +277 1 7.4281 17.2705 4.47377 6.46179 23.4452 -11.2721 +278 2 7.96797 18.0618 4.61565 -3.66399 -5.46425 9.5792 +279 2 7.28703 17.3462 3.52078 -0.310988 -11.8901 2.26571 +280 1 9.22893 17.063 12.2466 22.6161 -18.3078 -0.374418 +281 2 9.25634 16.2959 11.6379 -2.98004 10.6911 5.23864 +282 2 10.0783 16.9759 12.7442 -18.2994 12.1316 -6.13803 +283 1 13.3197 12.9538 7.95187 -9.96581 2.72298 -9.05352 +284 2 13.2593 12.2563 8.62517 4.24613 3.77329 1.00191 +285 2 13.899 13.6706 8.22561 11.1032 -0.425478 9.75376 +286 1 14.9719 2.96045 15.3396 1.81329 0.120121 -0.870248 +287 2 14.3995 2.21229 15.1018 3.59949 7.50345 -3.65154 +288 2 15.6901 3.005 14.6772 -10.8991 -3.85704 4.22675 +289 1 9.85324 15.5257 17.0014 3.97317 -4.57748 -3.47476 +290 2 10.3864 14.7538 16.7592 -3.54516 -0.814303 -2.23392 +291 2 9.2485 15.2429 17.6987 -0.194096 3.36496 6.55889 +292 1 11.2976 8.26736 16.5426 7.06128 19.5884 6.19806 +293 2 10.6048 7.82655 16.0501 -2.15009 -7.46249 -5.1526 +294 2 11.6506 7.64084 17.1804 -3.23764 -5.26669 1.48715 +295 1 3.80261 18.1891 16.7286 5.96532 3.63646 9.58286 +296 2 4.2558 17.5705 17.3068 2.57751 -13.4277 -2.28373 +297 2 3.88923 0.356458 17.2317 -6.08372 7.81341 -6.39572 +298 1 2.19516 4.11859 8.94937 -6.46461 1.56382 -5.27436 +299 2 3.07192 3.77694 8.7043 -7.24867 0.753394 12.5906 +300 2 2.01364 3.98399 9.90559 16.1239 2.6739 -11.0998 +301 1 9.88488 10.3605 9.72172 5.12637 14.4569 -2.91242 +302 2 9.60959 11.2332 9.33432 -0.0101703 -19.6763 14.6837 +303 2 10.1282 10.4603 10.6632 -8.0115 2.48909 -7.97128 +304 1 9.71465 0.804575 10.8512 21.7431 15.3431 10.1505 +305 2 9.2832 18.6897 11.2643 -8.53487 -4.69507 -4.97966 +306 2 9.18676 1.22081 10.1628 -13.1132 -5.80645 -3.94121 +307 1 9.20675 15.1716 10.2106 -23.935 -1.88548 4.57185 +308 2 8.85892 15.9372 9.71979 2.38257 -5.68301 1.50138 +309 2 8.39577 14.638 10.4071 17.7258 6.53325 -11.5344 +310 1 1.0072 9.34307 10.3251 -13.5607 -2.30165 -2.87521 +311 2 1.0259 10.3094 10.4263 12.3488 -1.76633 0.307332 +312 2 1.88127 8.96784 10.1532 -1.03643 13.7416 3.72628 +313 1 16.8438 4.87108 8.18901 -4.78961 0.896955 11.5039 +314 2 16.1406 5.46499 8.54396 15.0863 -10.4307 -3.41532 +315 2 17.2081 4.33923 8.92353 -6.78534 8.8584 -10.8667 +316 1 14.6587 14.7041 0.366828 1.30507 -0.478814 3.63059 +317 2 15.185 15.0332 1.12636 -7.04307 -0.464202 -11.0373 +318 2 13.8385 14.3426 0.742198 8.82268 0.591631 -2.33039 +319 1 3.54036 11.0513 9.61487 2.50715 2.61524 -7.45538 +320 2 3.63629 11.5626 10.435 -2.71976 -6.10697 -0.243655 +321 2 3.06413 11.634 8.99273 6.16009 -0.263385 5.30284 +322 1 11.0628 10.8412 1.29387 1.94664 2.31063 1.36488 +323 2 11.3352 11.6508 0.816723 -4.4237 -7.82009 8.11802 +324 2 10.1138 10.7005 1.1254 8.25661 2.0034 -0.662671 +325 1 13.2071 7.092 12.8743 -8.181 6.96481 -7.78695 +326 2 14.1492 6.89693 12.9368 4.59729 -0.0390769 -2.26511 +327 2 12.7747 6.23567 12.7699 0.0352738 -4.27477 4.68983 +328 1 9.62872 1.89049 0.957357 1.17656 -1.16236 13.2501 +329 2 8.73134 1.77169 0.632677 -1.73422 -2.0126 -6.33446 +330 2 10.2301 1.88378 0.211292 -0.739962 2.15457 -7.7161 +331 1 10.5914 13.525 4.7165 6.94092 6.03141 -14.7136 +332 2 11.5001 13.1966 4.5902 -6.55933 -2.4681 12.9436 +333 2 10.616 14.067 5.5206 3.43098 -5.16043 -1.25188 +334 1 14.3018 1.72484 10.9172 13.4371 11.1223 -9.93713 +335 2 15.1272 1.43467 10.5035 -1.81024 -10.6133 4.43081 +336 2 14.4134 2.68551 10.8564 -6.433 0.422524 6.62217 +337 1 14.6521 12.3877 11.7022 -8.45049 -6.71538 5.80805 +338 2 15.5103 12.5052 11.2413 -17.7577 -5.57988 -7.54306 +339 2 13.9188 12.0751 11.1197 22.5147 4.82958 0.534535 +340 1 8.2427 5.06906 9.80652 6.55588 21.6544 3.19941 +341 2 7.41824 5.23391 10.2944 2.41744 -11.9303 -3.89737 +342 2 8.21758 4.20856 9.37923 -10.585 -10.7296 4.55255 +343 1 1.58459 16.8369 18.3321 1.96955 3.78018 0.59611 +344 2 1.85004 17.2184 17.4898 0.0469727 3.49377 1.52109 +345 2 1.98826 15.9645 18.3052 -5.87072 -8.1408 0.0386171 +346 1 1.45085 17.2397 15.3384 19.3024 -11.6024 -7.75777 +347 2 1.52928 18.1033 15.7334 -7.82156 13.9033 4.46915 +348 2 0.523156 17.01 15.2404 -5.15812 1.64021 5.22009 +349 1 3.71432 5.60797 6.16821 -6.42766 23.1509 5.2389 +350 2 3.10788 6.20238 6.65309 4.74203 -10.8724 -0.844938 +351 2 4.31902 6.23597 5.73943 -0.58891 -7.80382 -7.69424 +352 1 12.3617 9.44178 14.1897 14.768 -21.5294 -7.13739 +353 2 12.6854 8.60646 13.7318 -7.61852 23.4532 21.1317 +354 2 12.1886 9.19254 15.1239 0.0190459 -2.13671 -14.4759 +355 1 4.02789 15.2847 6.90037 19.6963 3.91174 -8.53909 +356 2 3.59813 16.0446 6.4807 -5.57314 -2.58109 7.58101 +357 2 4.98627 15.4174 6.72455 -14.0806 -2.64155 5.91133 +358 1 0.604694 8.56382 14.8836 6.38519 14.8729 2.46932 +359 2 0.593576 9.52815 15.0331 -4.38489 -7.16014 1.99766 +360 2 1.21683 8.48632 14.1406 0.0450847 -3.26888 3.80333 +361 1 12.9907 8.33553 10.3435 -10.7244 11.0212 -25.595 +362 2 13.7217 7.85043 9.92864 1.48882 -4.14748 10.5805 +363 2 12.916 8.06476 11.2563 9.06532 -10.0671 12.5191 +364 1 15.3021 7.67479 3.50456 -15.706 -31.6797 19.6454 +365 2 14.5991 7.08356 3.22123 -2.84665 13.9574 -20.9494 +366 2 15.4859 7.21773 4.34079 18.8178 22.1978 3.49889 +367 1 17.3057 6.66581 0.0439089 -0.566439 -0.157214 -4.14934 +368 2 16.9415 5.80914 0.322205 -4.36129 9.908 -1.962 +369 2 16.5386 7.21525 18.4101 8.51434 -8.37768 3.91558 +370 1 8.82219 6.93132 7.84612 -10.1525 -9.67927 6.48857 +371 2 9.74438 7.17539 7.82243 13.4851 9.91198 -3.74634 +372 2 8.75511 6.31699 8.60098 -3.86074 2.18846 -4.69843 +373 1 12.3417 0.621389 1.18077 -6.9564 -3.41972 6.83906 +374 2 13.1525 0.726993 1.70017 3.48999 0.0677543 -9.59522 +375 2 12.4857 18.5505 0.551479 3.63823 3.88808 0.842467 +376 1 5.6677 15.1168 14.5202 -2.89809 14.409 3.62726 +377 2 4.73779 15.2069 14.7798 -2.10515 -4.92641 -4.42493 +378 2 5.95698 16.02 14.2745 1.37709 -12.0745 -2.57764 +379 1 3.85174 6.50812 1.71549 -1.87326 -9.92841 -7.94113 +380 2 3.40118 7.27684 1.32447 4.40945 3.56133 7.79633 +381 2 3.98293 6.6854 2.65555 -2.72837 5.07562 -0.486349 +382 1 3.88774 11.6179 12.2731 7.36248 2.53406 3.74193 +383 2 4.74563 11.9961 12.5096 3.21135 -1.44769 -3.24982 +384 2 3.26188 12.2215 12.6852 -7.1456 -2.35069 3.20446 +385 1 5.4326 3.86602 15.8669 5.46195 27.5847 5.5501 +386 2 6.12196 3.19729 15.7751 -0.292732 -1.96119 -5.07149 +387 2 5.89955 4.7414 15.9262 -11.6823 -23.746 -2.53289 +388 1 14.4519 10.31 4.40466 -0.198609 -22.4452 -14.1251 +389 2 14.647 9.76314 5.18938 0.972168 3.21729 -6.37484 +390 2 14.6939 9.77999 3.59617 -3.45576 13.8176 24.0335 +391 1 7.91012 17.3396 9.21881 -3.47249 -5.09989 3.31179 +392 2 7.12992 17.5549 9.76562 5.48476 5.05439 -11.164 +393 2 8.00718 17.9294 8.44912 -7.46491 1.16212 7.11091 +394 1 4.51961 14.4455 3.97665 1.46094 13.6517 19.4367 +395 2 4.57851 15.3966 4.28178 1.46521 -27.5553 -6.05216 +396 2 4.65578 13.8277 4.74009 -3.41874 17.0045 -15.0106 +397 1 14.2914 7.39173 15.7568 2.67151 4.01398 13.8033 +398 2 15.2382 7.26829 15.5879 -5.04223 1.8615 0.0507223 +399 2 14.2621 7.71182 16.6758 1.37252 -0.910778 -10.0112 +400 1 2.89282 18.2219 1.89623 16.0954 20.7868 19.4211 +401 2 2.43498 17.5738 1.38145 -10.8581 -14.0242 -17.961 +402 2 2.20473 18.7378 2.33948 1.00824 -0.59586 0.163903 +403 1 7.97772 1.60288 4.53639 1.7563 -9.68985 13.008 +404 2 7.31922 2.029 3.97737 7.04095 6.46018 -8.6135 +405 2 8.84264 2.02013 4.43356 -4.53303 1.60821 -5.92451 +406 1 2.59943 14.1332 17.7414 -8.95394 -18.2677 -2.38171 +407 2 1.94944 13.4122 17.9464 12.5244 20.6844 1.19004 +408 2 3.47205 13.7759 17.9983 -8.8914 0.728457 0.900702 +409 1 0.745112 1.69912 13.8711 11.2473 3.52367 -11.146 +410 2 0.914419 1.4049 14.7673 -7.77297 1.70239 6.88788 +411 2 18.4589 1.93825 13.7842 -0.334419 -0.897106 4.15254 +412 1 4.53599 18.6175 13.9535 -3.4557 6.59794 -4.70782 +413 2 5.46815 18.3485 13.9788 -8.18255 -2.00556 -1.03369 +414 2 4.11637 18.3402 14.7801 5.6735 0.958275 2.99437 +415 1 7.096 0.531319 18.3551 -0.694611 7.4496 8.80978 +416 2 7.23097 0.178113 17.4735 2.95576 -3.96306 -6.42653 +417 2 6.14085 0.633472 18.4745 3.33236 6.58102 0.363951 +418 1 16.0915 18.4336 14.0959 0.427379 -0.396215 -8.58483 +419 2 15.3508 17.8946 13.7703 3.59427 8.97013 10.1541 +420 2 15.9721 18.7209 15.0186 -4.35198 -12.8399 -3.85995 +421 1 10.0849 4.5187 16.2702 4.73223 -5.50586 5.92697 +422 2 10.9866 4.63155 16.5807 5.77761 8.19399 -3.69287 +423 2 10.0461 3.5611 16.1717 -6.80252 -1.66686 -4.51665 +424 1 15.8725 17.8845 4.41654 -12.5209 12.7326 5.37596 +425 2 16.3916 18.7124 4.49019 -1.68969 -11.5252 -1.94643 +426 2 14.9593 18.1341 4.67479 17.449 -5.50076 1.40971 +427 1 6.95668 17.3709 13.7302 27.0332 5.97859 23.7699 +428 2 7.35597 17.5596 14.624 -6.60353 0.436933 -26.7426 +429 2 7.73328 17.3113 13.1176 -17.9234 -0.691624 11.5164 +430 1 13.2886 6.54141 6.708 -19.4099 -8.32294 21.4331 +431 2 14.1944 6.83212 6.62317 10.4169 5.52785 -11.9279 +432 2 12.8902 6.38702 5.85009 7.8467 0.777822 -14.5162 +433 1 7.70655 2.38278 9.20977 12.6343 0.60353 -10.8933 +434 2 7.2325 2.23152 10.0347 -6.87682 0.627979 2.4454 +435 2 7.14224 2.1131 8.46352 -1.96859 -1.38987 10.9664 +436 1 15.1599 14.8609 13.6555 2.14917 -2.72077 3.1958 +437 2 15.0894 15.1454 14.5818 -4.10533 -0.470809 -6.08849 +438 2 14.3857 15.1548 13.1581 4.50097 1.9243 4.2209 +439 1 9.31836 8.32368 3.71602 18.5592 -2.51714 11.5674 +440 2 10.1335 8.79007 3.99631 -8.14035 -3.14117 -4.90658 +441 2 9.4898 7.3827 3.90713 -7.2783 5.8685 -3.93333 +442 1 17.7186 13.4905 16.4359 -1.51289 22.2408 -13.156 +443 2 16.7625 13.3639 16.3649 1.62841 -7.26982 3.16217 +444 2 17.8329 14.3608 15.9953 4.68582 -10.1291 6.26608 +445 1 5.02763 10.6563 2.64305 -2.13744 -9.22816 3.31541 +446 2 5.67739 10.1782 3.18798 -3.0773 8.85482 -0.1212 +447 2 4.59818 11.3042 3.21285 3.70326 -1.5106 2.19329 +448 1 3.72149 8.34459 10.2919 -0.179455 -7.68631 -12.7595 +449 2 3.82782 9.26393 10.0171 0.460185 9.10653 3.72446 +450 2 3.7984 8.31763 11.2506 0.24707 1.5831 -0.943414 +451 1 16.0782 7.09232 6.27704 3.78536 -20.3998 -1.61032 +452 2 16.8668 7.5306 6.63092 -6.12864 4.03671 -1.53431 +453 2 16.2929 6.14181 6.32149 -2.48234 12.3559 -4.92911 +454 1 15.1572 7.02511 9.10581 3.8117 16.1939 -22.7388 +455 2 15.9823 7.33517 9.52567 -10.9007 1.4123 -2.48218 +456 2 15.0452 7.59247 8.29613 6.45133 -12.7204 22.5185 +457 1 6.42341 13.1088 12.8743 -8.95622 -6.97199 -8.56847 +458 2 7.13157 12.5608 13.2501 0.579484 9.04377 -2.95583 +459 2 6.27581 13.8943 13.4207 1.62934 -6.42573 5.92996 +460 1 12.1251 4.48872 13.0852 20.6978 11.8008 -11.4801 +461 2 12.1861 4.63134 14.0408 -7.38726 -2.06828 2.45652 +462 2 11.3124 4.06154 12.8314 -12.072 -7.43803 9.29181 +463 1 11.3394 8.19587 7.85205 11.1059 -10.4301 17.8484 +464 2 12.0348 7.61277 7.52234 0.357557 0.521252 -13.0071 +465 2 11.6101 8.269 8.78041 -6.91702 7.4869 -1.95681 +466 1 17.1867 10.7889 7.4395 14.5297 -2.81026 -23.5185 +467 2 17.9096 10.1869 7.16109 -12.9834 1.71839 15.1597 +468 2 17.0415 11.3048 6.62611 -4.1729 8.16775 12.482 +469 1 5.24074 18.1281 11.0581 -15.2173 -3.98599 -8.34189 +470 2 4.58924 18.0057 11.7782 10.2636 1.95052 -8.13419 +471 2 4.73144 18.0737 10.2167 7.33147 4.07832 13.9505 +472 1 7.57528 17.5815 1.8237 -4.07192 12.6902 15.9513 +473 2 7.93668 16.805 1.40258 -2.93669 -7.99436 -16.24 +474 2 7.56667 18.3008 1.17772 -1.22407 -7.09592 -6.98677 +475 1 1.89335 12.9293 13.6081 -2.83392 -4.38044 7.70492 +476 2 1.42634 12.2947 14.1785 7.13969 5.03303 -2.73416 +477 2 2.14611 13.6729 14.1857 -2.01709 -2.63559 -9.61881 +478 1 9.71667 6.79197 14.8165 -19.737 27.0922 8.68981 +479 2 9.89359 5.91802 15.1417 7.60675 -24.7177 2.15595 +480 2 10.032 6.8882 13.9194 5.10262 -3.22926 -9.37061 +481 1 15.2334 4.35765 10.7756 -27.5978 -16.2477 -22.3588 +482 2 16.1684 4.22394 10.6591 16.9939 1.30069 13.5789 +483 2 15.041 5.04225 11.4098 10.4595 11.1452 11.1309 +484 1 11.214 6.13659 0.181715 -19.0514 -14.6776 -12.5318 +485 2 11.2124 5.17659 0.0304417 14.0569 6.29109 5.62342 +486 2 10.2823 6.34718 18.6411 6.7491 10.3457 6.1137 +487 1 0.148583 11.3373 15.1258 -19.5821 15.0001 -24.2151 +488 2 18.1981 11.6758 14.382 16.6378 -5.64999 24.2973 +489 2 18.7581 12.0391 15.8029 -7.9684 -6.15355 -5.02438 +490 1 7.07881 9.17505 7.27008 -6.43803 -1.74166 -4.58486 +491 2 6.45798 8.45812 7.48524 7.10939 3.15379 4.24177 +492 2 7.95401 8.76045 7.26417 -3.66954 2.28396 2.09633 +493 1 18.4168 15.4276 12.3546 -3.43386 -0.549873 -4.48624 +494 2 0.729474 15.5504 12.2627 0.527014 -4.05801 2.94094 +495 2 18.0745 15.7474 11.5108 -2.98934 0.409485 0.218187 +496 1 16.554 4.36499 5.23729 20.8954 -6.05263 25.9175 +497 2 16.7683 4.14077 6.16822 -16.8827 1.59137 -12.628 +498 2 17.4495 4.42836 4.87212 -5.6372 6.04853 -15.3532 +499 1 17.7678 3.07292 10.7257 -2.33819 12.1961 -2.64827 +500 2 0.05876 3.27172 10.9273 -5.50289 -7.01135 -0.383438 +501 2 17.6798 2.21428 10.2822 5.02163 -0.151153 2.81987 +502 1 12.2925 0.0394171 10.1485 -5.03026 26.5344 11.6637 +503 2 11.4572 0.407352 10.526 9.87088 -12.259 -12.5756 +504 2 12.9102 0.803778 10.1803 -6.63246 -15.2789 0.0865208 +505 1 10.3587 9.80679 12.3603 15.6128 10.3756 0.750657 +506 2 11.1656 9.89562 12.9016 -9.14674 -1.49827 1.04164 +507 2 10.2822 8.8615 12.2126 -4.78815 -8.04326 1.85351 +508 1 0.512396 2.83902 7.01376 3.84696 0.0782361 15.1378 +509 2 0.640445 3.53836 7.66576 0.959953 5.26089 -8.6545 +510 2 0.680944 2.06786 7.56376 2.06531 -6.50055 -6.8896 +511 1 0.435055 15.2675 6.92024 15.2549 -35.398 4.87844 +512 2 0.621058 15.2814 7.87767 -6.30652 4.63478 -5.55491 +513 2 0.767833 14.3496 6.68755 -16.1257 30.2961 -2.9732 +514 1 16.9932 7.01767 15.3053 -26.5651 1.45521 -6.17716 +515 2 17.7481 7.60304 15.1777 11.1425 -6.61607 -1.97906 +516 2 17.2478 6.0923 15.4082 16.5215 2.79636 5.68328 +517 1 9.018 12.4253 8.12635 6.95093 19.302 15.9025 +518 2 9.42759 11.8305 7.48541 -10.9396 -6.20971 -13.8418 +519 2 8.05723 12.5431 8.02215 9.94353 -10.4145 -8.12359 +520 1 1.2603 1.92339 3.03777 4.00037 -11.2111 -0.333139 +521 2 0.985763 2.4239 2.25859 3.27899 1.87382 4.37683 +522 2 1.94434 2.40743 3.53125 -8.95634 4.24445 -6.71947 +523 1 4.13152 15.1081 9.6737 -15.9579 5.42681 13.2475 +524 2 4.06185 15.276 8.72578 6.37214 -2.02945 -0.454299 +525 2 5.01049 14.775 9.87491 6.77649 -3.08542 -5.82222 +526 1 7.18656 2.18024 14.5742 6.63684 0.423238 1.66106 +527 2 6.97291 1.78224 13.7284 -0.102066 -5.66692 0.745345 +528 2 7.71431 2.94579 14.3335 0.160548 4.26015 2.86325 +529 1 18.6004 14.6938 2.16823 2.76542 -5.02319 -0.780568 +530 2 0.802927 15.1539 2.18876 5.80577 -4.93168 -0.456722 +531 2 17.9585 15.3989 2.13554 -15.1748 6.08707 3.47143 +532 1 9.94779 2.77101 12.9402 13.7079 -4.8088 0.992354 +533 2 9.86912 2.18708 12.1681 -6.43941 0.85112 1.08944 +534 2 9.26112 3.44421 12.9098 -9.63803 -0.00730006 -3.05418 +535 1 2.82654 8.93218 13.0337 -16.8853 -9.00607 0.122573 +536 2 3.25687 9.752 12.7946 6.59476 15.835 -2.70012 +537 2 3.50997 8.32082 13.3007 12.5319 -6.06263 8.37491 +538 1 3.22862 8.37837 3.65188 -0.226515 1.69475 29.0088 +539 2 3.688 9.03214 3.10752 1.26352 6.15003 5.24259 +540 2 3.37942 8.56962 4.62044 0.873457 0.138782 -29.442 +541 1 5.6209 7.19208 8.52428 9.74274 9.28918 -7.76376 +542 2 5.82768 6.24803 8.58864 -11.1579 -1.95789 2.42461 +543 2 4.98617 7.45468 9.2041 -0.288223 -8.23268 4.91577 +544 1 14.8711 1.29057 2.00464 8.31119 17.2873 -6.28041 +545 2 14.835 2.11415 2.48745 -9.33397 1.40045 17.6104 +546 2 15.2356 1.62076 1.17953 -0.998754 -14.9614 -12.238 +547 1 8.25883 15.2026 0.830681 5.29747 -5.49957 9.6471 +548 2 8.95156 15.1522 1.50066 13.8019 -1.55539 -6.59484 +549 2 7.5748 14.6468 1.22478 -8.81297 0.605757 -6.77665 +550 1 15.6232 1.34362 7.23598 -18.647 -1.91314 -11.6656 +551 2 14.9897 0.764646 6.76092 12.0508 5.58891 7.1025 +552 2 15.1447 2.18632 7.33027 3.5178 -4.19741 5.22167 +553 1 4.94904 13.0769 18.5237 9.6722 0.589191 0.374268 +554 2 5.36668 13.208 0.749415 -4.04426 -2.7658 -6.21312 +555 2 5.63686 13.3362 17.8955 -3.04446 1.7017 1.4528 +556 1 15.3696 8.47999 18.1528 -1.21138 17.1653 -12.6794 +557 2 15.695 9.10606 17.469 -1.13375 -12.9806 6.06144 +558 2 15.1122 9.07709 0.225504 3.72099 -3.98362 5.25331 +559 1 12.0892 3.03182 18.3639 -14.1234 30.4246 -7.06661 +560 2 12.0418 2.65673 0.600248 11.0312 -14.2758 -1.1161 +561 2 12.4684 2.43863 17.7097 5.58993 -13.4699 6.64437 +562 1 13.2076 12.6677 5.18878 -11.1257 12.6934 -18.8931 +563 2 13.6382 11.873 4.85103 6.50507 -2.50005 7.23376 +564 2 13.4408 12.7972 6.11334 1.90386 -8.97209 5.02297 +565 1 6.04179 7.07685 0.0416979 2.64097 -12.2137 0.441028 +566 2 5.97681 7.98433 18.9573 -0.86164 23.926 -2.06041 +567 2 5.22747 6.68409 0.369779 -2.28588 -4.24693 2.31783 +568 1 17.7316 15.9939 15.0114 -15.9363 1.83518 -2.01139 +569 2 16.8954 16.4456 15.035 -7.98632 8.38962 22.0218 +570 2 17.7728 15.8943 14.0703 21.4922 -14.9825 -23.1623 +571 1 13.1856 0.993654 16.5812 4.51688 -6.04585 -7.39508 +572 2 14.1484 0.841574 16.6066 -7.22778 -1.30407 6.3933 +573 2 12.7998 0.141541 16.3207 3.39554 1.08214 8.76474 +574 1 11.0918 14.5789 7.23122 -0.0827639 9.53574 4.16562 +575 2 10.4295 14.1218 7.74457 -13.7426 -4.81361 3.6986 +576 2 11.9118 14.1808 7.52276 7.59678 -9.08814 -4.3045 +577 1 17.5016 8.6119 2.09076 15.8147 11.2146 7.10458 +578 2 16.6678 8.4072 2.52184 -8.49554 -5.1851 -0.954934 +579 2 17.6089 8.02126 1.34907 -7.08963 -15.2245 -7.94382 +580 1 12.3468 7.97644 1.98939 8.16003 1.60059 13.0036 +581 2 12.1059 8.91014 1.92161 -4.12319 -5.14517 -8.91961 +582 2 11.9653 7.48445 1.25112 -3.43761 0.267259 -0.201848 +583 1 11.9018 14.6174 10.3415 -1.61415 6.01794 0.545715 +584 2 12.1103 13.7968 9.87035 -7.85836 7.68399 3.13223 +585 2 10.9576 14.8558 10.2015 13.8599 -12.9225 1.87067 +586 1 6.88302 7.0351 15.5985 0.0361083 -3.88964 -3.36213 +587 2 7.78537 7.14813 15.233 -9.24764 2.66089 10.2853 +588 2 6.74206 7.63616 16.3488 6.91006 -2.15529 -8.72434 +589 1 7.99721 4.71198 13.4628 5.66523 -8.00363 0.660216 +590 2 7.27921 4.81457 12.8289 -1.54019 0.966988 -4.0678 +591 2 8.48375 5.53924 13.4635 -1.88422 3.21799 -0.709238 +592 1 13.4036 12.1691 14.2716 3.14721 5.94494 7.46154 +593 2 13.2707 11.2057 14.207 -2.45791 4.15826 -3.3873 +594 2 13.8696 12.4652 13.4742 -1.1423 -6.74147 -2.23487 +595 1 14.8179 9.43426 7.29668 -6.36233 -11.9657 -8.30628 +596 2 15.5946 9.98871 7.43973 -1.00608 2.08043 5.84882 +597 2 14.0417 9.81939 7.70717 2.29675 7.38462 3.05591 +598 1 12.6631 17.0342 3.08686 -0.647851 26.0284 13.2632 +599 2 13.0189 17.4392 3.9047 -6.62985 -13.126 -8.67274 +600 2 12.0984 17.7464 2.72355 6.77056 -16.0012 0.625123 +601 1 1.16659 7.14982 17.4488 -22.2539 0.168591 -14.6305 +602 2 0.289944 6.86023 17.7803 4.99818 12.4666 0.0121858 +603 2 0.976074 7.62854 16.6106 6.60301 -8.93429 9.27073 +604 1 12.7913 5.13723 15.6659 26.8924 -5.83385 4.65231 +605 2 13.5397 4.50448 15.7352 -14.8898 5.20509 -1.35689 +606 2 13.2524 6.00122 15.6738 -9.3883 -7.24139 -3.09335 +607 1 2.50717 3.39641 5.02544 -4.94238 4.99772 43.075 +608 2 1.86502 3.10611 5.74586 16.3729 8.7954 -24.7542 +609 2 3.07143 4.08677 5.47722 -17.3542 -15.0389 -19.8763 +610 1 8.33721 11.2536 13.4671 -31.8218 12.3906 11.8554 +611 2 8.27902 11.0779 14.4347 20.4393 -8.01279 -19.4916 +612 2 9.11607 10.9377 12.9927 6.53682 -12.2231 14.6875 +613 1 12.8982 1.36842 13.3393 -2.38428 13.9081 -24.9925 +614 2 13.3657 1.32357 12.4816 4.13856 -5.14841 14.3736 +615 2 12.4149 2.20238 13.2267 1.28817 -6.58848 11.7421 +616 1 6.36101 13.6632 2.13728 5.84509 3.64922 20.165 +617 2 5.80267 14.0802 2.81815 -1.42815 -2.61112 -9.48922 +618 2 6.96781 13.1347 2.6793 2.58248 -4.73497 -8.11447 +619 1 15.9275 6.58906 12.776 -13.2255 -11.9143 -7.63467 +620 2 16.5079 7.05171 12.1721 3.66176 7.36442 -5.52267 +621 2 16.2877 6.70509 13.653 8.87525 3.50761 9.55012 +622 1 16.8403 0.7053 9.59425 -10.8287 -6.51914 0.180126 +623 2 16.6786 18.4058 9.8215 7.5744 10.512 -7.34073 +624 2 16.3431 0.86575 8.76743 6.96547 -2.88011 1.97602 +625 1 6.14042 11.7236 8.37935 -13.4401 -40.1875 -12.4491 +626 2 5.21965 11.5178 8.67227 17.9013 7.59491 -1.88002 +627 2 6.47134 10.8481 8.01351 -3.81201 28.7474 13.2691 +628 1 2.85976 8.65216 0.41009 29.1416 -12.2873 -0.261225 +629 2 2.35956 8.19684 18.3517 -12.3126 13.3733 12.5274 +630 2 2.40304 9.34487 0.902258 -18.8466 -1.4582 -10.1697 +631 1 10.1473 10.4614 6.51315 3.14709 -2.48115 -1.63688 +632 2 10.5898 9.76783 7.02035 -1.8228 -0.602608 0.477386 +633 2 10.6086 10.4674 5.65949 -3.20151 3.83187 3.87642 +634 1 6.7508 15.7003 6.55579 -3.66232 16.9823 8.74149 +635 2 7.17195 16.1106 7.3235 -0.889674 -7.99055 3.10182 +636 2 6.78205 16.4211 5.90999 7.33374 -8.97986 -9.58603 +637 1 6.44532 13.1371 5.60194 -4.00449 -9.15456 -0.382904 +638 2 6.60496 14.011 5.98141 3.67218 -1.64471 2.17047 +639 2 6.02503 12.5975 6.28414 2.5909 4.19611 1.89612 +640 1 16.8064 12.5561 9.82402 0.581653 -6.91502 5.14494 +641 2 16.9779 11.8749 9.14515 -1.61791 10.9714 -1.54419 +642 2 16.8208 13.4318 9.41997 2.06437 -4.78596 -5.13994 +643 1 6.05928 2.9442 2.82556 1.25802 -7.30262 2.82421 +644 2 6.27309 3.83898 2.57954 7.79966 17.9541 1.71249 +645 2 5.71238 2.57735 2.0082 -4.75947 -10.8151 -3.84195 +646 1 10.8984 3.29285 3.29228 5.15622 -3.79068 5.20633 +647 2 10.3299 4.01236 3.59418 -0.748764 -1.25701 -6.51467 +648 2 10.5397 2.95527 2.46424 -5.70132 0.188995 -0.608043 +ITEM: TIMESTEP +30 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.74009 7.04233 17.938 19.1777 -3.19214 -7.49225 +2 2 7.80649 7.00854 18.1244 -14.093 -2.50808 3.42214 +3 2 8.91581 6.41795 17.2214 -5.10918 0.448792 4.2696 +4 1 18.6171 8.27942 6.83462 -12.32 14.9255 -3.46236 +5 2 0.0642234 8.14825 5.88022 8.8384 -8.96826 -1.74433 +6 2 0.471057 7.61284 7.31078 8.78566 -8.6497 2.36561 +7 1 8.41948 18.604 6.83196 -7.31709 9.89495 0.0475112 +8 2 9.31705 0.18142 6.57583 5.64527 1.22556 -0.782264 +9 2 7.87491 0.677395 6.4693 3.49499 -4.79599 0.294282 +10 1 6.58709 1.81441 11.6738 -9.76955 10.2882 13.9968 +11 2 5.91112 2.25954 12.2323 7.89399 -9.20897 -13.0604 +12 2 6.23103 0.933026 11.5157 -4.21921 -5.78552 -0.720022 +13 1 7.09426 5.71845 2.37594 5.34919 -15.1759 8.94595 +14 2 6.67772 6.26147 3.06365 -7.93287 1.62685 -13.8275 +15 2 6.91151 6.0744 1.49958 -5.30903 10.9181 0.766926 +16 1 16.2033 10.1932 16.1102 25.1038 -14.8345 -4.68499 +17 2 17.1811 10.2276 15.9712 -26.7737 6.31541 3.48142 +18 2 15.8826 11.0697 16.3304 -0.495148 7.87416 1.92317 +19 1 10.6275 14.9681 2.33481 4.63974 12.4061 -8.88569 +20 2 10.5525 14.5877 3.21874 0.475518 -3.93386 2.29786 +21 2 11.1735 15.7673 2.45016 -5.17002 -7.496 3.37274 +22 1 17.1558 8.25893 10.4932 -6.40301 -0.466841 8.61163 +23 2 16.8014 9.01233 11.0035 2.41501 -9.01393 -1.96838 +24 2 17.9838 8.5563 10.1014 3.2569 5.37409 0.738347 +25 1 14.813 15.8567 16.3841 0.422148 6.97991 -3.34819 +26 2 13.9021 16.1825 16.382 -1.86689 -1.60487 0.125842 +27 2 14.9304 15.3999 17.2268 -3.27081 -1.81494 5.72738 +28 1 12.1434 13.4089 0.461034 6.76243 -11.3039 1.90058 +29 2 12.0273 13.3364 18.1404 -4.47443 10.9984 5.76772 +30 2 11.5266 14.0334 0.870976 -2.78837 -1.53089 -3.65161 +31 1 9.27697 5.43199 4.02458 -7.91052 -7.29997 -7.2337 +32 2 8.84655 5.10212 4.83549 0.848683 4.58319 -8.36746 +33 2 8.59135 5.35221 3.31849 12.3251 4.32217 11.9863 +34 1 1.81829 4.21991 11.6429 6.07059 -17.107 12.3126 +35 2 1.72876 5.16246 11.8251 -3.56412 5.27463 0.970751 +36 2 2.25117 3.81723 12.4298 -6.51129 5.35444 -16.475 +37 1 2.00161 6.82001 8.34658 4.25884 -4.64897 6.26816 +38 2 2.3883 7.2423 9.12712 0.123274 4.2764 -6.11357 +39 2 2.06217 5.87963 8.57415 -6.89287 0.824976 -4.38383 +40 1 5.40511 4.42179 7.95561 5.36611 -11.1614 7.9457 +41 2 5.37943 3.4545 8.00651 8.07147 0.734095 -1.60012 +42 2 4.74745 4.62621 7.29567 -7.31573 12.7226 -8.35968 +43 1 3.27976 2.92717 17.5269 -2.61436 17.3567 -5.43199 +44 2 3.96706 3.40529 17.0145 -5.77518 -10.9103 1.73426 +45 2 2.73687 3.63363 17.9263 6.62302 -5.15647 1.61932 +46 1 7.46558 5.28438 6.08942 -8.18758 20.8516 25.3808 +47 2 7.86532 6.07017 6.49581 9.60667 -5.12281 -7.79846 +48 2 6.93507 4.98822 6.84771 -4.13165 -15.5457 -12.384 +49 1 9.77734 7.00329 11.9774 4.77277 1.25087 12.6605 +50 2 10.3838 6.43919 11.4894 -2.2356 -0.795019 -4.50196 +51 2 9.03042 7.20515 11.401 -0.391647 0.322053 -6.58611 +52 1 14.0794 3.58589 8.07965 12.1281 -3.68665 15.0324 +53 2 13.9224 4.24013 7.41233 -5.94016 13.6931 -8.832 +54 2 14.4997 4.05823 8.8235 -7.49262 -7.6028 -6.06268 +55 1 4.66909 17.2524 3.98463 -11.974 -6.63251 3.44703 +56 2 5.54996 17.5659 4.2137 3.76078 6.9996 -9.15965 +57 2 4.29017 17.6906 3.19701 6.52868 -0.394456 6.67531 +58 1 16.4992 16.6027 10.1206 -21.6924 9.71885 22.6747 +59 2 15.7868 16.8403 10.7484 14.9981 -6.02669 -3.77625 +60 2 16.0155 16.0666 9.49209 1.7904 -6.99745 -11.6514 +61 1 1.97502 4.88502 0.412911 -0.608987 3.87721 -1.07962 +62 2 2.72637 5.27959 0.897705 -7.05745 -2.41863 1.64934 +63 2 1.49341 5.65258 18.7073 9.30006 -4.776 -0.647009 +64 1 11.7125 13.3331 16.298 -5.19121 -16.9939 -9.12414 +65 2 11.2215 12.495 16.3147 -7.17559 5.00423 10.7559 +66 2 12.3053 13.159 15.554 3.20757 8.82206 0.62976 +67 1 10.1364 11.0457 16.9267 -8.25027 -0.64471 -2.79768 +68 2 10.5138 10.1546 16.8726 -0.811727 0.343111 1.84422 +69 2 9.16904 10.9405 16.8614 10.4447 -1.98124 -2.23602 +70 1 11.7196 17.4866 13.4532 0.688277 4.88805 11.3616 +71 2 12.4565 17.1915 12.9059 2.31052 0.20251 -3.63622 +72 2 11.8417 18.4468 13.5823 3.75325 -8.25615 -8.02045 +73 1 6.38436 9.31353 12.2227 -10.6166 9.98881 15.1897 +74 2 6.82973 8.96514 11.4526 14.2312 0.227315 -7.303 +75 2 6.92633 10.0292 12.607 -0.115112 -8.7725 -6.80594 +76 1 16.2215 12.7689 2.69197 14.2202 2.36446 -2.70282 +77 2 17.0315 13.2181 2.42332 4.27042 -4.81366 0.268886 +78 2 15.6299 13.4985 2.86911 -16.5638 6.55953 0.86202 +79 1 0.643858 12.5819 5.90471 10.4355 0.0636689 -1.96923 +80 2 0.972356 12.3928 5.01972 -0.601341 2.21783 -2.79245 +81 2 18.3387 12.6591 5.78833 -5.81166 2.35718 1.0682 +82 1 5.2154 16.4273 18.4533 5.05017 -7.28804 7.26993 +83 2 5.85096 15.759 18.1791 -0.38035 -3.88529 -12.2081 +84 2 5.53459 16.6741 0.678671 -3.42073 7.449 3.19712 +85 1 0.551654 7.64481 4.10641 16.2354 21.1246 -10.5626 +86 2 18.6183 7.98546 3.39603 3.07966 -1.83327 6.1622 +87 2 1.42708 8.08449 3.93576 -19.267 -16.5837 1.18512 +88 1 3.12227 8.91534 6.50802 24.2291 -0.585626 7.1452 +89 2 3.7382 8.63748 7.22391 -17.1573 3.17125 -13.7643 +90 2 2.22482 8.81583 6.82729 -5.68465 -1.73896 5.22193 +91 1 7.30086 10.3189 16.2323 -15.6545 -0.122126 6.34207 +92 2 6.59019 10.5178 15.6183 5.33711 0.792532 -4.64 +93 2 6.81196 10.2023 17.0683 9.00195 1.1125 -0.831229 +94 1 11.1139 1.03369 5.01342 4.3303 1.68398 -12.6705 +95 2 11.3068 1.80352 4.46111 -2.07011 7.18197 9.97137 +96 2 10.7762 0.428462 4.34613 -4.44642 -9.51924 3.00218 +97 1 4.39584 2.7383 13.2149 -0.390466 4.89753 -17.2666 +98 2 4.70663 3.24132 13.9776 -1.24631 -10.9908 10.3904 +99 2 4.24133 1.79775 13.4334 4.65854 7.0575 9.14841 +100 1 8.38523 10.0971 1.80824 -1.28714 19.1329 -0.644156 +101 2 8.30354 10.8052 2.48172 0.822207 -7.93375 -7.37013 +102 2 8.79223 9.36658 2.27287 1.71369 -9.23717 4.71722 +103 1 10.4729 1.73916 15.5717 11.6995 -6.53653 -13.4069 +104 2 11.3877 1.45477 15.4183 -5.50109 4.13915 12.9036 +105 2 10.2466 2.11684 14.7151 -9.31794 0.949785 -3.28817 +106 1 2.72932 12.8923 7.77007 2.13638 -2.03638 4.95693 +107 2 3.24355 13.6603 7.47881 -3.48119 -3.6232 -2.9431 +108 2 2.14523 12.6528 7.03806 -2.13852 4.70731 1.87174 +109 1 3.67999 11.6951 5.25129 1.06179 2.30609 -7.65488 +110 2 3.48397 10.8814 5.71277 1.07183 -5.39866 6.20843 +111 2 2.98047 11.7882 4.59744 -0.426908 3.81831 -2.62473 +112 1 6.82829 14.472 16.8976 7.24547 -11.7087 -0.510459 +113 2 7.70535 14.0752 16.845 -3.98439 5.03843 1.85271 +114 2 6.50852 14.4918 15.986 -3.30226 9.38599 0.302494 +115 1 14.1912 14.5549 3.37889 -4.65321 -1.5346 -2.40618 +116 2 13.6567 15.3531 3.27958 4.16996 -0.562804 -5.50008 +117 2 13.6356 13.9417 3.87468 5.16163 -0.564442 6.07906 +118 1 8.32326 18.1549 16.0383 38.0123 0.723105 5.33509 +119 2 8.90126 17.4596 16.3629 -14.277 -18.5473 4.85232 +120 2 9.02384 0.130446 15.7883 -15.867 17.9211 -5.43461 +121 1 4.72767 1.62379 4.93271 -17.6379 -0.985038 1.9521 +122 2 3.81401 1.95679 4.84992 11.4813 -1.52324 3.97162 +123 2 5.23321 2.13073 4.30096 3.99283 5.81443 -10.8958 +124 1 15.0185 12.7583 16.4307 33.5549 -15.7429 -8.88385 +125 2 14.6322 13.2399 17.156 -17.5625 6.9837 5.99474 +126 2 14.4538 12.6352 15.6516 -10.3238 6.55553 8.00439 +127 1 15.7718 18.4254 16.841 -12.0797 -5.1952 -2.21012 +128 2 16.3284 18.515 17.6327 0.946096 -4.9786 -5.09166 +129 2 15.4084 17.517 16.8347 11.7053 8.22526 2.07191 +130 1 1.18057 1.17309 16.5558 11.0398 2.91722 -0.500753 +131 2 1.84524 1.84688 16.7601 6.86303 -5.43895 -3.7977 +132 2 0.618264 1.22767 17.321 -11.8887 1.06625 6.89733 +133 1 18.1125 4.54155 15.913 0.560198 2.18648 6.37111 +134 2 18.4591 4.08913 15.1466 2.75843 -6.08521 -5.17788 +135 2 18.7597 4.4472 16.6204 -1.36812 0.49592 -3.69459 +136 1 12.2402 16.9779 16.1352 2.31512 -6.99762 -15.3414 +137 2 11.5952 16.4515 16.6081 -8.3163 0.999648 8.5775 +138 2 12.0081 16.8315 15.1982 2.22798 9.47321 6.13039 +139 1 15.9623 2.53119 18.0207 2.93621 -4.28086 -0.122131 +140 2 15.5695 3.22825 18.5544 -2.43998 7.63429 -5.2422 +141 2 15.6676 2.68289 17.1026 2.19807 1.36349 7.25858 +142 1 6.70368 13.8359 10.2288 1.24588 -18.109 -1.49583 +143 2 6.57782 13.5214 11.1319 -1.51171 6.96132 4.85856 +144 2 6.68827 13.0063 9.72453 -2.19505 9.55036 -5.72862 +145 1 10.1309 18.2871 2.76796 -14.3596 -6.47533 0.342864 +146 2 10.2029 0.342366 2.11266 2.51428 7.52943 -3.11917 +147 2 9.22516 17.9366 2.63576 15.7336 3.88756 2.50188 +148 1 2.99532 17.7363 6.09725 27.6457 -0.367768 9.57951 +149 2 2.17297 17.7876 5.61616 -10.9588 -3.8104 -13.5012 +150 2 3.724 17.7747 5.44639 -16.7072 2.57282 0.579206 +151 1 12.5761 16.9143 8.00615 -13.9856 15.3012 3.95273 +152 2 11.7456 16.4539 7.8426 4.73348 -10.9119 -5.17088 +153 2 12.3021 17.5765 8.66814 13.2598 -3.61726 -0.932189 +154 1 14.882 15.2803 8.24971 10.681 -0.761738 -5.80123 +155 2 14.3225 16.029 8.07669 -22.8014 8.12514 9.31404 +156 2 15.4227 15.298 7.45407 7.11517 -7.78554 -3.15381 +157 1 17.6329 18.2578 0.365715 -0.853361 22.9802 4.00517 +158 2 18.5235 17.9699 0.161776 5.93848 -16.2402 -3.481 +159 2 17.7627 0.512218 0.708086 -5.13428 -6.58263 -1.39758 +160 1 0.88251 10.4012 1.38524 10.7451 13.2218 -5.20703 +161 2 0.0659506 9.93794 1.52098 -14.8693 -14.1338 10.0664 +162 2 0.630973 11.1288 0.804044 1.28572 5.25949 -2.19783 +163 1 1.64115 12.2217 3.35193 -3.18006 -13.1055 -18.8251 +164 2 1.37082 11.5062 2.75067 2.88651 -5.3868 11.6868 +165 2 1.67765 12.9428 2.72371 4.09986 15.3051 6.03005 +166 1 0.58147 17.2398 4.87485 -10.389 -0.219728 20.623 +167 2 -0.122589 17.8866 4.86961 1.40048 11.6397 -9.93657 +168 2 0.410626 16.8027 5.7206 11.49 -10.3372 -7.14723 +169 1 1.11352 0.964392 9.43077 -4.94184 3.64088 -20.8453 +170 2 1.20387 0.588778 10.3126 -0.847456 -3.79009 5.67247 +171 2 0.226103 0.72639 9.1141 8.25621 -1.04795 9.52173 +172 1 16.7603 2.33922 13.2874 -3.33679 -13.7714 7.5216 +173 2 16.8475 2.59005 12.3669 3.49604 3.27514 -7.50745 +174 2 16.539 1.38388 13.2956 1.74648 12.4468 1.52133 +175 1 2.56382 15.8252 12.169 -1.32309 5.18512 -19.2115 +176 2 3.14843 15.408 12.7949 3.95332 -3.2625 9.96296 +177 2 3.02181 15.7534 11.31 -3.03818 -3.40517 4.91625 +178 1 16.4251 15.6276 5.98753 2.75225 -2.61515 5.58966 +179 2 17.3447 15.6415 6.33695 -10.8386 4.94036 -7.12539 +180 2 16.2312 16.4474 5.48017 12.4296 -10.8984 6.26847 +181 1 5.80144 5.06794 11.7894 5.49032 -3.99323 1.93812 +182 2 5.42192 5.63452 12.4754 -2.65214 7.25607 -4.62846 +183 2 5.38258 4.20716 11.9011 -4.64894 2.39601 -1.00669 +184 1 15.1781 4.86184 0.728524 -4.34825 6.76152 14.6306 +185 2 15.2668 4.67158 1.68153 -8.60174 -1.32446 -9.75027 +186 2 14.3367 5.34751 19.2902 10.4034 -8.61994 -3.37533 +187 1 16.3306 16.3549 2.10387 -3.60874 -8.17165 19.4202 +188 2 16.1436 16.7757 2.96383 0.821724 -8.86269 -6.10473 +189 2 16.4161 17.1032 1.53428 7.22132 12.8567 -17.8694 +190 1 0.267773 4.86229 3.80408 10.7738 -14.2237 3.39069 +191 2 0.48911 5.8014 3.76313 1.80944 1.44211 5.87769 +192 2 1.0394 4.38382 4.18029 -13.1099 14.4171 -4.44332 +193 1 2.95694 15.0447 15.0954 -6.10325 -16.3486 9.96696 +194 2 2.71126 14.628 15.9563 6.59243 11.9398 -10.1751 +195 2 2.48371 15.8886 15.0723 0.827451 0.569437 4.39106 +196 1 1.13642 14.6155 9.54099 -48.9591 -6.29818 10.1377 +197 2 2.0574 14.6763 9.37448 31.1561 -9.052 1.81392 +198 2 0.917533 13.7788 10.0133 17.9146 13.2649 -10.59 +199 1 13.6267 16.618 11.5309 -14.0517 -2.94194 4.54584 +200 2 13.2284 17.3872 11.0909 1.36391 -4.96948 -3.72009 +201 2 13.0435 15.8681 11.2876 10.4622 6.11411 -5.34277 +202 1 4.69594 1.47637 0.748111 -12.1621 -0.739309 -0.414133 +203 2 4.0907 2.00679 0.20438 8.77888 0.173625 -0.66482 +204 2 4.10511 0.858084 1.19895 3.99089 -4.2391 -0.703649 +205 1 1.43799 18.5334 11.8677 4.48354 -19.5441 -2.70285 +206 2 1.28309 0.34807 12.6964 -2.38454 7.77338 6.6957 +207 2 1.65634 17.6099 12.1011 0.514199 12.3996 -0.852918 +208 1 11.5339 10.1172 4.0507 5.82948 9.6286 -18.4863 +209 2 11.2843 10.5321 3.18756 5.15824 -8.38498 16.2271 +210 2 12.5124 10.093 4.04255 -10.5657 0.881913 4.0585 +211 1 8.32129 12.1582 3.72502 1.53352 8.77417 8.44763 +212 2 9.09494 12.6645 4.01218 5.78128 -3.64141 -7.92941 +213 2 7.76311 12.2518 4.50437 -12.3191 -3.17133 -0.801295 +214 1 14.3738 4.02512 3.28302 13.4457 8.56362 13.3606 +215 2 15.0833 4.15474 3.94873 -8.39321 -4.82495 -4.85792 +216 2 13.6328 4.57269 3.59478 1.91801 -3.79011 -4.78214 +217 1 5.59001 1.69403 7.5104 -22.1497 -9.71937 -16.3739 +218 2 4.92965 1.04535 7.86703 17.0022 15.2682 -3.23125 +219 2 5.33019 1.76513 6.54994 10.6546 -4.2597 24.8978 +220 1 17.8762 1.11593 4.87562 6.9502 3.59021 1.61777 +221 2 18.6375 1.36949 4.33979 -2.23157 -1.53514 -7.48501 +222 2 17.9489 1.70322 5.63717 -7.55192 -1.12522 1.72169 +223 1 6.82082 9.41417 4.48467 7.28036 -1.61815 9.25922 +224 2 6.87733 9.61398 5.42883 -5.7945 0.587378 -0.0554941 +225 2 7.74179 9.22243 4.26363 -0.0627487 -3.5933 -6.80471 +226 1 2.67079 14.9403 1.9639 10.8093 -10.5544 22.1131 +227 2 3.25117 14.6591 2.70117 -12.0207 4.93014 -5.95014 +228 2 3.29732 15.1077 1.27121 3.13815 4.27624 -15.5237 +229 1 17.3067 12.913 13.1683 10.6019 -31.6629 4.62367 +230 2 16.4497 13.2737 13.3972 -3.78483 16.2252 -3.80314 +231 2 17.8834 13.5891 12.8053 -8.28955 15.595 1.58636 +232 1 14.9867 10.5664 1.39303 17.3246 -3.28745 6.09509 +233 2 15.5958 11.2392 1.752 -7.58668 -4.78908 -2.0363 +234 2 14.1528 11.003 1.29225 -13.717 8.26159 -1.38466 +235 1 5.69708 6.86241 4.54741 10.2551 2.99419 0.383868 +236 2 6.12873 7.74081 4.58523 -8.39477 -7.3362 -0.690872 +237 2 6.29159 6.23392 4.98874 0.140081 3.89587 3.34658 +238 1 8.04621 8.27418 10.2318 -1.25624 6.00125 -7.48209 +239 2 8.67166 8.94213 9.92965 6.80147 7.39227 7.14523 +240 2 7.62794 8.03247 9.40376 -7.32264 -11.607 2.12748 +241 1 13.4746 18.3625 5.78211 -13.502 7.51331 -2.26288 +242 2 12.7551 0.364455 5.61988 6.67968 -8.24018 -2.37745 +243 2 13.1168 17.8207 6.50434 6.50164 -0.829271 0.111391 +244 1 0.226362 2.58719 0.131375 -15.5932 24.0028 11.6326 +245 2 17.9693 2.93929 18.6394 3.5786 -16.3529 -5.12341 +246 2 0.708035 3.3711 0.44675 7.58398 -8.21165 -4.7522 +247 1 12.703 11.0237 9.75181 24.9284 -7.65781 8.94422 +248 2 11.7937 10.9936 9.46616 -11.7502 -8.38149 -1.23796 +249 2 12.9608 10.1029 9.99094 -10.5021 9.57622 -2.72207 +250 1 0.761974 12.2205 11.0816 -4.15363 -6.09516 -21.355 +251 2 18.4366 12.288 11.0674 3.38909 -0.754442 8.49561 +252 2 1.11175 12.4338 11.9478 -3.68194 5.91832 8.04416 +253 1 5.07253 7.26896 13.4467 3.90397 -0.0234352 3.77117 +254 2 5.61152 7.96046 13.0436 -1.11485 3.21213 -6.58832 +255 2 5.53238 7.13074 14.2827 -1.05457 -4.33313 3.81413 +256 1 1.23629 6.9109 11.8337 28.2892 12.95 23.6673 +257 2 0.51347 7.34016 11.3984 -13.736 7.24235 -8.87687 +258 2 1.75935 7.64669 12.2495 -13.9201 -17.9067 -15.9983 +259 1 15.4873 9.53008 12.3182 -0.383493 4.12812 -8.89679 +260 2 15.0655 10.399 12.2152 3.51435 -2.6855 7.45914 +261 2 15.2649 9.14784 13.1724 -1.90612 6.52608 2.19385 +262 1 16.6085 12.8345 5.46896 -3.55761 11.1023 -1.95777 +263 2 16.4419 13.7896 5.48874 0.313493 -0.193839 12.6146 +264 2 16.4475 12.6632 4.54137 -0.0496347 -14.7353 -8.15109 +265 1 6.20534 9.98194 0.0899104 18.0768 -8.37359 0.258846 +266 2 5.59572 10.4068 0.70246 -2.59094 3.74961 3.89273 +267 2 7.08249 9.9872 0.527613 -14.0474 2.02387 3.58276 +268 1 12.3397 6.07843 4.05984 1.81271 11.939 -8.21694 +269 2 12.2328 6.8085 3.41842 8.48996 -4.45606 3.14495 +270 2 11.4615 5.7138 4.10837 -10.8447 -6.35959 3.05037 +271 1 0.186481 12.7968 0.194157 8.45417 -0.362633 0.823389 +272 2 0.122538 13.4857 0.868002 -3.08717 1.48078 1.57348 +273 2 18.4164 13.184 18.057 -2.66731 -2.48236 -4.34426 +274 1 3.77162 18.5917 8.57827 -20.4554 1.45559 2.68175 +275 2 3.52322 17.9715 7.87805 6.33007 3.25639 -1.82086 +276 2 2.90938 0.367014 8.76804 7.74592 -0.0744794 5.639 +277 1 7.46409 17.2961 4.48316 -14.1198 -17.2275 8.02552 +278 2 7.88946 18.1398 4.59819 4.06261 16.9953 -5.43573 +279 2 7.32948 17.1504 3.54137 6.62361 8.1702 -3.03871 +280 1 9.24056 17.0796 12.2607 -1.29913 -0.841935 -6.42698 +281 2 9.19718 16.4258 11.5387 7.57092 0.344645 9.78983 +282 2 10.1052 16.9888 12.7016 -6.07497 2.05659 -6.06408 +283 1 13.326 12.928 7.96212 4.69357 25.6567 2.07593 +284 2 13.3763 12.2768 8.65803 -4.91574 -13.7878 2.50151 +285 2 13.7353 13.7181 8.35204 8.56042 -2.58857 -8.38859 +286 1 14.9538 2.97298 15.3382 -4.29462 -11.8182 -2.96981 +287 2 14.4639 2.15222 15.1644 -2.78402 11.1896 3.17375 +288 2 15.6292 2.97829 14.6488 1.75 3.70602 0.0805282 +289 1 9.85487 15.5414 16.9955 1.72232 -1.82893 -0.169847 +290 2 10.3837 14.7676 16.7382 -3.42626 -0.271454 1.71497 +291 2 9.29261 15.2923 17.7497 4.44449 2.55726 -1.27949 +292 1 11.3089 8.30526 16.5494 -6.04997 -6.2326 7.21044 +293 2 10.5881 7.89563 16.0543 2.01853 1.78394 -3.12513 +294 2 11.4835 7.65722 17.2517 2.74023 7.81545 -1.84368 +295 1 3.836 18.1836 16.7517 -7.13385 -19.1452 -23.0441 +296 2 4.27407 17.4593 17.223 1.84106 9.67264 7.83483 +297 2 3.88222 0.348533 17.2402 4.94653 11.64 14.7969 +298 1 2.18178 4.13609 8.93005 8.1701 -0.774865 9.73019 +299 2 3.0913 3.90524 8.75773 5.46766 -1.37508 -11.1104 +300 2 2.14869 4.01328 9.88774 -11.2166 4.12208 2.959 +301 1 9.87742 10.3647 9.70242 2.63105 14.1486 10.9213 +302 2 9.56679 11.2208 9.35298 -0.359428 -9.80694 -0.658425 +303 2 10.1334 10.5423 10.6269 -4.00587 -8.10964 -6.10976 +304 1 9.70429 0.823826 10.8553 -14.0108 4.16215 1.0267 +305 2 9.1278 18.77 11.1938 11.0832 -7.32823 7.11532 +306 2 9.14207 1.22722 10.1856 4.51331 8.02138 -6.87563 +307 1 9.20617 15.1402 10.2178 -11.609 -5.72992 -0.101326 +308 2 8.7465 15.767 9.6415 2.03963 4.50002 1.17892 +309 2 8.51696 14.4821 10.4282 6.2553 7.07807 -5.66984 +310 1 0.996164 9.40777 10.3157 -31.4617 35.4735 1.80375 +311 2 1.02993 10.3821 10.3914 -11.0752 -10.4846 4.01107 +312 2 1.89609 9.22017 10.2201 37.6387 -20.6805 -6.1303 +313 1 16.8786 4.85128 8.17759 -11.2506 16.3288 -5.48708 +314 2 16.2388 5.56314 8.38188 8.44756 -9.04525 0.78656 +315 2 16.9626 4.34108 8.98054 4.36808 -7.38136 2.74573 +316 1 14.6815 14.711 0.319263 14.4838 0.937126 -3.06264 +317 2 15.2721 14.9301 1.06391 -7.87321 4.75235 -6.44468 +318 2 13.8763 14.3724 0.714255 -5.91657 -4.41648 2.02008 +319 1 3.57415 11.0448 9.58418 2.91679 3.40936 2.58946 +320 2 3.69173 11.5263 10.4228 -3.34733 -6.02301 -1.37626 +321 2 3.07399 11.6483 9.00652 3.80152 0.245021 0.575116 +322 1 11.1013 10.8086 1.33492 -13.1151 -1.75228 0.351043 +323 2 11.4484 11.639 0.990604 2.68761 3.85867 -0.677593 +324 2 10.1644 10.7789 1.04773 13.6271 -2.80152 6.25142 +325 1 13.1828 7.11823 12.837 13.875 6.93007 -2.08809 +326 2 14.1546 7.00576 12.8731 -8.73741 -0.33434 -1.11439 +327 2 12.8407 6.21951 12.8306 -5.12621 -6.60309 0.0889066 +328 1 9.62491 1.88499 0.973614 -3.42399 -6.06492 -12.2684 +329 2 8.82152 1.4846 0.597998 2.34171 8.22807 3.07369 +330 2 10.1781 2.12743 0.21359 -0.384483 0.556473 6.61436 +331 1 10.6031 13.5334 4.66686 13.636 -3.8461 -1.22567 +332 2 11.4763 13.1252 4.55872 -4.58351 -5.15517 0.0143246 +333 2 10.7077 13.9241 5.53959 -7.66657 9.10334 4.04553 +334 1 14.3485 1.75735 10.9256 -1.10429 -17.7549 1.09656 +335 2 15.1861 1.44338 10.54 -2.80824 6.90847 2.1648 +336 2 14.3834 2.71874 10.9625 8.08978 3.11888 -5.0019 +337 1 14.6333 12.3432 11.6996 -1.39952 -9.16637 -24.1357 +338 2 15.3681 12.4502 11.0746 9.0546 4.11007 14.4837 +339 2 13.9355 12.122 11.0753 -11.0061 -2.1546 9.49113 +340 1 8.24004 5.06512 9.81661 -6.73852 -15.0928 -6.1646 +341 2 7.43321 5.24609 10.2868 -7.68507 10.8263 10.6715 +342 2 8.07004 4.14881 9.53169 13.9201 5.19095 -3.88371 +343 1 1.57861 16.855 18.3455 -3.6047 -18.8696 23.6299 +344 2 1.81992 17.2862 17.5419 10.6717 7.49965 -18.3027 +345 2 1.88846 15.9289 18.2434 -7.51751 10.9825 -1.36554 +346 1 1.48469 17.2399 15.3369 -30.5992 8.85894 1.58219 +347 2 1.52903 18.0991 15.7763 5.64601 2.15314 -3.36931 +348 2 0.515015 17.0623 15.2815 21.6878 -4.25813 -0.913042 +349 1 3.6961 5.66103 6.13276 1.27154 -4.68408 -0.174538 +350 2 3.02861 6.15393 6.634 5.94065 6.05513 -0.564102 +351 2 4.2706 6.29315 5.66099 -8.13711 -1.6893 2.05746 +352 1 12.3863 9.46112 14.1898 5.64676 -22.9439 1.72589 +353 2 12.6155 8.61212 13.7476 3.53191 14.2422 4.21489 +354 2 12.2183 9.16782 15.1036 -0.67103 6.17556 -4.58111 +355 1 4.03262 15.2884 6.88962 -6.96122 -2.16466 3.53978 +356 2 3.61008 16.076 6.4989 3.67472 -5.21865 6.04109 +357 2 4.98914 15.3892 6.82497 3.29203 7.08348 -5.36605 +358 1 0.610585 8.57451 14.9167 2.06858 8.16468 9.66942 +359 2 0.571526 9.5334 15.101 -0.509723 -6.74541 -4.80249 +360 2 1.24768 8.49017 14.2004 3.24343 3.39805 -1.00154 +361 1 12.9947 8.30502 10.3347 -2.10898 5.96297 -3.02925 +362 2 13.7245 7.79451 9.98073 4.34503 -3.62623 -11.9067 +363 2 13.0194 8.04092 11.2546 -7.35013 -0.655157 9.61409 +364 1 15.3021 7.68636 3.53463 20.0464 32.042 -6.64886 +365 2 14.6007 7.2355 3.06802 -7.18972 -17.1123 8.01585 +366 2 15.7144 7.29713 4.32433 -16.1768 -11.7678 -0.766084 +367 1 17.3034 6.68003 0.0493874 -1.84179 -13.5509 -2.88881 +368 2 16.9519 5.78424 0.161568 0.711034 6.10552 3.25575 +369 2 16.5083 7.2036 18.5276 -0.473138 7.46776 -7.84911 +370 1 8.84315 6.93181 7.84628 -0.943806 11.0529 -13.3888 +371 2 9.77771 7.20927 7.80441 -6.03996 -2.82935 4.46193 +372 2 8.74315 6.27043 8.54219 4.24547 -3.80386 5.92931 +373 1 12.3578 0.616451 1.20223 7.02437 -6.39463 -1.478 +374 2 13.2861 0.535705 1.47006 -5.02329 6.70293 3.96338 +375 2 12.2631 18.6802 0.444477 -1.70715 1.25222 -1.43865 +376 1 5.64724 15.135 14.5406 -0.604856 -11.7009 0.79572 +377 2 4.70142 15.1669 14.7844 5.92695 5.15448 -4.69419 +378 2 5.94602 16.0188 14.2721 -2.36621 0.047849 -2.09121 +379 1 3.86203 6.47491 1.73695 1.36817 -0.22553 5.39386 +380 2 3.46749 7.3178 1.48065 -2.80916 3.79134 -8.60259 +381 2 4.09027 6.61791 2.66801 -1.52617 -4.74348 -3.78665 +382 1 3.89615 11.6258 12.3135 -4.96985 -7.23752 -2.42851 +383 2 4.76636 11.9561 12.5635 2.33504 5.86151 0.242199 +384 2 3.23901 12.1927 12.7515 8.69891 -3.88643 -0.482475 +385 1 5.40213 3.8611 15.8693 10.8945 -12.2769 2.09816 +386 2 6.15363 3.21949 15.8699 -18.4435 12.0745 -5.1575 +387 2 5.79254 4.73962 15.8533 3.23601 3.32406 0.742539 +388 1 14.4255 10.2871 4.42158 -5.00773 -17.9107 13.5675 +389 2 14.5181 9.70279 5.20492 2.69814 10.8256 -8.91808 +390 2 14.7837 9.77905 3.68069 -0.206993 2.85241 0.289205 +391 1 7.87167 17.3723 9.20121 -10.8695 6.25183 -3.73994 +392 2 7.03582 17.6433 9.5986 1.28641 -7.15132 6.24862 +393 2 7.9635 17.9776 8.45108 8.3983 -5.79413 -1.77097 +394 1 4.52981 14.473 3.9851 -7.27149 14.4717 16.1092 +395 2 4.4292 15.3844 4.34508 5.86047 -13.4028 -12.5476 +396 2 4.51094 13.8931 4.76638 0.622359 -0.721789 -7.97238 +397 1 14.2548 7.40188 15.768 -9.88191 3.80355 1.83721 +398 2 15.2055 7.32768 15.6782 10.3356 -1.93634 -2.70959 +399 2 14.1214 7.72007 16.6658 2.42251 2.42868 0.921806 +400 1 2.92318 18.2319 1.90056 8.21916 -2.84793 -3.01579 +401 2 2.38261 17.6158 1.3774 3.82694 3.92633 -2.29165 +402 2 2.32657 18.895 2.2462 -10.4983 4.84254 7.82145 +403 1 7.9872 1.59624 4.55123 -13.2342 7.82044 -5.09514 +404 2 7.38456 2.15817 4.04087 -4.12207 -9.74777 1.09289 +405 2 8.829 1.94177 4.28864 19.9647 -0.586446 1.64736 +406 1 2.52886 14.1331 17.7106 9.56011 -8.28606 7.0204 +407 2 2.01365 13.3855 18.0679 -1.20108 10.5585 -3.23507 +408 2 3.45026 13.9294 17.9721 -7.58546 -2.42865 -2.00823 +409 1 0.784808 1.71729 13.877 -22.3729 3.14932 11.7627 +410 2 0.820241 1.39718 14.7912 6.0833 4.21121 -6.47959 +411 2 18.4913 1.99435 13.7832 17.5446 -4.15928 -6.69512 +412 1 4.49906 18.6473 13.9354 -18.7945 1.8826 8.61585 +413 2 5.41644 18.4141 14.0419 11.9469 -5.27484 -6.26214 +414 2 4.07897 18.3597 14.7657 2.79866 5.45516 -5.58976 +415 1 7.09283 0.599142 18.3486 34.6471 -4.12786 -6.63011 +416 2 7.39021 0.234617 17.4878 -9.84259 3.28252 9.67216 +417 2 6.14438 0.553251 18.3894 -16.3447 5.16139 0.014819 +418 1 16.0881 18.4309 14.0453 5.06229 7.716 24.0321 +419 2 15.2482 18.0804 13.8032 -16.2536 -8.6858 -12.6141 +420 2 15.9952 18.587 15.0073 9.58514 -0.127307 -10.5143 +421 1 10.0776 4.50678 16.2676 12.8821 37.0646 3.31891 +422 2 10.9819 4.89306 16.3611 -10.6263 -20.5161 -3.34059 +423 2 10.1424 3.55939 16.3223 6.24363 -16.5382 -1.58612 +424 1 15.8992 17.8398 4.41934 12.2004 7.51097 -4.98004 +425 2 16.3832 18.6941 4.42415 -3.71288 -10.9395 3.02327 +426 2 14.9903 18.0494 4.62819 -9.96916 6.21932 6.5896 +427 1 6.98832 17.3871 13.7576 13.6855 5.49553 14.8404 +428 2 7.37965 17.5993 14.631 -4.71479 -0.449691 -14.3122 +429 2 7.76575 17.2997 13.1656 -13.1106 -1.1113 5.84114 +430 1 13.2824 6.5097 6.67953 4.56939 11.9611 -5.54075 +431 2 14.0532 7.04843 6.47095 5.72005 -2.26771 11.4806 +432 2 12.9258 6.37058 5.8058 -10.6331 -8.36185 -8.97535 +433 1 7.75109 2.3756 9.23631 -5.33505 -3.40336 15.3372 +434 2 7.18759 2.24157 10.0186 8.87424 2.78019 0.355864 +435 2 7.20141 2.0575 8.52046 -4.61968 -0.366971 -12.063 +436 1 15.1734 14.8403 13.6669 0.441467 -1.73197 5.96822 +437 2 15.0738 15.2212 14.5455 0.591215 -4.0348 4.14746 +438 2 14.518 15.2716 13.122 -1.09719 2.73458 -8.10719 +439 1 9.35119 8.31644 3.739 2.66762 7.66889 5.69365 +440 2 10.15 8.71947 4.13947 -5.98752 -7.29531 -6.80605 +441 2 9.38201 7.35632 3.87197 4.69073 2.10751 1.74529 +442 1 17.751 13.5231 16.4139 1.76506 1.52762 0.696064 +443 2 16.8205 13.2419 16.3833 1.32585 7.25436 -2.93419 +444 2 17.8025 14.3962 15.9827 -4.54797 -4.37418 0.927992 +445 1 4.99908 10.6417 2.69781 -10.2301 11.821 9.59097 +446 2 5.61637 10.2237 3.29708 11.0389 -6.03173 2.08237 +447 2 4.70065 11.4181 3.20566 0.509198 -9.80178 -10.0294 +448 1 3.73671 8.33589 10.2301 0.811909 12.56 -11.1256 +449 2 3.79833 9.26935 9.95307 1.30999 -3.93497 -1.66187 +450 2 3.73931 8.38186 11.1831 0.045476 -4.76093 8.99044 +451 1 16.0469 7.05349 6.21752 -8.36922 7.98368 -7.54927 +452 2 16.8656 7.47651 6.4961 3.44749 0.07849 4.67395 +453 2 16.1438 6.1088 6.32704 6.52122 -4.4821 -3.05144 +454 1 15.1289 7.04368 9.08785 10.4694 9.8467 1.75835 +455 2 15.8264 7.38614 9.67453 -3.18259 -3.19274 -6.50653 +456 2 15.1274 7.66298 8.34243 -1.48772 -3.73631 0.00250057 +457 1 6.37899 13.0555 12.8241 7.15095 -9.93714 4.62427 +458 2 7.14263 12.6042 13.2293 -5.49135 0.351509 -10.6671 +459 2 6.23455 13.8287 13.3737 -7.10156 7.81238 6.40695 +460 1 12.1361 4.49173 13.0886 -33.3605 -9.49617 -7.12831 +461 2 12.0495 4.6518 14.0281 12.9755 3.95225 11.8447 +462 2 11.274 4.06082 12.879 23.5373 6.19102 -2.9945 +463 1 11.3516 8.18262 7.87035 -14.4325 7.02786 -3.11936 +464 2 12.0471 7.65769 7.46008 8.6713 -7.43794 3.47117 +465 2 11.5359 8.26397 8.81258 10.0684 -2.50636 2.15934 +466 1 17.1915 10.8124 7.44959 -16.1176 10.6393 13.8832 +467 2 17.9047 10.1798 7.28217 -0.931293 1.13858 -10.0543 +468 2 16.9855 11.3827 6.68215 10.1883 -6.89581 1.62445 +469 1 5.25104 18.1119 11.0466 -2.03712 6.82198 -5.53245 +470 2 4.55844 17.9395 11.7023 5.22213 1.54215 -0.259713 +471 2 4.79647 18.4173 10.2467 -3.05137 -7.80568 1.06144 +472 1 7.59144 17.5428 1.82585 2.02366 6.3387 -27.4892 +473 2 7.8094 16.7742 1.27336 1.17923 0.135637 10.7354 +474 2 7.55288 18.254 1.15356 -7.65387 -5.36774 12.2151 +475 1 1.92063 12.9184 13.6023 -9.91855 -8.75107 -5.23832 +476 2 1.37345 12.2779 14.0844 5.59931 4.65398 4.03533 +477 2 2.08932 13.6638 14.189 3.88592 4.92281 2.07481 +478 1 9.68002 6.79239 14.8375 -5.9785 1.55821 1.53848 +479 2 9.8605 5.87105 15.0454 -1.79232 -6.14635 7.43903 +480 2 10.0701 6.92553 13.9753 -0.129146 4.69231 -11.1498 +481 1 15.2463 4.32976 10.758 3.34542 15.1712 12.775 +482 2 16.1952 4.27653 10.855 10.1577 -17.3864 -7.84826 +483 2 15.0718 4.96713 11.4544 -13.5892 3.80238 -1.28771 +484 1 11.2223 6.14234 0.184515 14.935 15.986 0.702496 +485 2 11.3427 5.2537 -0.179589 -9.34658 -3.11564 3.17557 +486 2 10.3073 6.45674 18.8196 -5.33379 -13.1911 -7.29958 +487 1 0.101128 11.3538 15.0994 -20.5112 19.1646 -16.3994 +488 2 18.0631 11.5965 14.4157 17.8209 -6.40715 11.0417 +489 2 18.7281 12.1498 15.6639 -2.69532 -11.5931 2.167 +490 1 7.07341 9.21118 7.26397 13.6545 -4.38359 1.14819 +491 2 6.46912 8.52168 7.54812 -6.91606 -6.22713 3.38737 +492 2 7.94495 8.78194 7.35853 -7.81842 8.24868 -3.32543 +493 1 18.379 15.4045 12.3485 -3.73833 -6.55761 4.14497 +494 2 0.693581 15.4288 12.2501 6.70794 3.85833 -5.56408 +495 2 17.998 15.8269 11.5664 0.97425 0.444703 -1.66759 +496 1 16.5516 4.36462 5.23826 -5.38189 5.67955 -17.8631 +497 2 16.655 4.28498 6.19256 13.2509 -4.37544 3.08954 +498 2 17.3965 4.59413 4.7818 -8.47419 -6.89051 15.5314 +499 1 17.7443 3.09877 10.7286 3.04827 -10.7181 -6.87848 +500 2 0.0283995 3.26624 10.9392 2.02267 5.05617 3.97045 +501 2 17.7464 2.2027 10.3321 -6.96828 10.7891 3.50943 +502 1 12.2779 0.0212452 10.1338 -0.475788 -3.12763 3.03365 +503 2 11.45 0.377358 10.5143 6.17492 -0.459139 -6.32122 +504 2 12.9469 0.721114 10.1609 -4.48032 5.31969 3.75096 +505 1 10.3747 9.79435 12.3975 0.995366 2.64477 2.84838 +506 2 11.0916 9.86004 13.0462 0.88472 -0.940912 -1.26785 +507 2 10.2331 8.84374 12.2815 -0.892889 0.226532 -0.81052 +508 1 0.549483 2.84316 7.02126 -1.47246 -21.9217 -16.5589 +509 2 0.577314 3.5439 7.66737 3.67317 4.63089 12.4819 +510 2 0.765862 2.00117 7.45653 1.04632 13.6877 4.9994 +511 1 0.405258 15.2829 6.93023 -2.49907 -5.43649 4.98244 +512 2 0.538371 14.8975 7.8327 2.16571 9.44122 -16.3162 +513 2 0.725684 14.6278 6.28848 -1.93707 -3.30699 10.9749 +514 1 17.0129 7.01771 15.2646 8.6122 -7.5627 -5.22629 +515 2 17.8138 7.53109 15.1273 -3.20292 15.4854 -2.58719 +516 2 17.4051 6.15342 15.4314 -10.2841 -6.73634 6.86556 +517 1 9.05466 12.4444 8.11302 13.0521 -10.4864 -20.5516 +518 2 9.3276 11.8473 7.39447 15.1337 1.48797 7.8591 +519 2 8.12011 12.397 7.99286 -24.7878 10.4099 9.23055 +520 1 1.26093 1.88381 3.01396 9.71768 11.5305 -0.318626 +521 2 0.781341 2.25664 2.27301 -4.68813 -2.91629 -4.97973 +522 2 1.78505 2.63319 3.35529 -3.04295 -14.2735 3.58948 +523 1 4.11799 15.1078 9.73252 4.576 2.76804 -1.92408 +524 2 4.09335 15.377 8.80945 -5.53143 0.588802 -2.3225 +525 2 5.02333 14.7824 9.83323 -1.70794 -2.53339 7.76874 +526 1 7.21252 2.18262 14.5895 -3.17269 -14.8219 8.52343 +527 2 7.02371 1.74902 13.748 4.05246 3.09826 3.19753 +528 2 7.71073 2.97164 14.4061 4.58862 11.2949 -7.92291 +529 1 18.5773 14.6793 2.1781 -14.8885 -13.9434 -3.10254 +530 2 0.806981 15.0773 2.13409 4.68638 9.16713 1.06255 +531 2 17.8879 15.3584 2.08187 6.00104 3.32119 3.09374 +532 1 9.95988 2.75708 12.9307 -3.19888 4.8993 -0.068744 +533 2 9.83509 2.14797 12.1955 3.80206 -8.82317 -3.94881 +534 2 9.20326 3.3528 12.8696 -1.08171 3.11286 5.06453 +535 1 2.85334 8.94069 13.0534 -9.07349 -10.7547 -1.24525 +536 2 3.30632 9.75091 12.8027 2.98523 12.1914 -0.768468 +537 2 3.53212 8.32042 13.3313 9.61222 -2.32206 4.81477 +538 1 3.22451 8.40753 3.67121 22.1548 25.1655 0.793749 +539 2 3.78763 9.07745 3.2153 -17.2399 -11.2925 0.757254 +540 2 3.40605 8.58793 4.60238 -4.67213 -6.04062 1.9181 +541 1 5.62069 7.18926 8.53747 6.69229 -2.05947 9.74796 +542 2 5.86853 6.28591 8.76536 -0.744086 -3.6627 -12.9201 +543 2 5.09246 7.43537 9.3012 -7.69944 9.66912 -1.05292 +544 1 14.8771 1.33506 1.99369 -4.37531 -14.3045 14.6387 +545 2 14.6174 2.14132 2.47402 3.99094 2.69357 -12.1219 +546 2 15.1274 1.48157 1.08098 3.94771 15.4277 -5.2716 +547 1 8.29964 15.2018 0.824762 -0.280237 2.12341 -18.5848 +548 2 9.0741 15.0554 1.38374 0.657448 -4.01578 8.69554 +549 2 7.56069 14.656 1.13255 5.04945 -5.16558 7.75703 +550 1 15.6052 1.34643 7.22407 3.75056 4.73875 0.699016 +551 2 15.0587 0.773182 6.67423 -5.35564 1.12746 0.995868 +552 2 15.1053 2.16848 7.37587 -1.8024 -6.33902 1.47434 +553 1 4.99443 13.0609 18.5093 -5.69789 -0.343563 -13.2097 +554 2 5.39232 13.2306 0.720212 5.08054 -1.92613 6.3414 +555 2 5.7137 13.1567 17.8693 -5.50653 4.49423 4.11534 +556 1 15.3782 8.49607 18.1492 -5.08872 -0.806473 3.30258 +557 2 15.7135 9.0139 17.4023 0.0404722 4.09908 2.1153 +558 2 15.1698 9.14329 0.203973 4.81283 -1.94937 -4.21801 +559 1 12.0917 3.05456 18.3485 5.25344 -19.9367 5.19329 +560 2 12.3328 2.56101 0.492796 -7.10973 11.5886 11.7441 +561 2 12.4167 2.41374 17.7115 -1.86526 8.77132 -18.5664 +562 1 13.1991 12.6728 5.17615 -0.124316 -0.0560055 4.18836 +563 2 13.6438 11.8331 5.03438 2.42254 -3.05364 -13.3032 +564 2 13.4089 12.8359 6.10375 -5.84435 4.2533 1.84347 +565 1 6.03469 7.1207 0.0631469 12.4635 -7.18562 -1.52206 +566 2 5.88549 8.01359 19.0305 -4.09863 7.65543 -4.79966 +567 2 5.21365 6.64029 0.190066 -5.29753 1.61074 5.21091 +568 1 17.6997 15.9613 14.987 30.7149 -12.4194 32.4504 +569 2 16.8862 16.4214 15.1458 -18.1669 6.52853 -13.961 +570 2 17.8877 15.7083 14.0822 -14.2113 6.66636 -19.3843 +571 1 13.1806 0.977208 16.5993 3.21446 -7.78263 -3.05852 +572 2 14.1069 0.725878 16.7441 -1.84519 3.55213 2.46319 +573 2 12.7536 0.148831 16.339 0.610986 0.436683 6.04854 +574 1 11.0624 14.5912 7.28204 -11.2181 -3.76258 -2.73638 +575 2 10.3867 13.9846 7.62705 2.11873 3.9908 3.08505 +576 2 11.9143 14.2091 7.50586 0.261112 -7.43153 0.664812 +577 1 17.506 8.58052 2.09005 -0.444247 -11.7988 -12.468 +578 2 16.6642 8.31502 2.4773 -2.50704 5.84538 6.9832 +579 2 17.563 7.99026 1.31874 6.86903 3.37396 8.78538 +580 1 12.3502 7.95652 1.98027 -3.36099 -5.49894 -2.13311 +581 2 11.9195 8.80992 1.98547 0.506131 9.65618 1.3531 +582 2 11.9377 7.50693 1.23044 6.6222 -7.49408 4.60604 +583 1 11.9327 14.6311 10.3511 -13.8226 21.3891 7.58711 +584 2 12.0851 13.8189 9.91206 10.3006 -23.5502 -10.4516 +585 2 11.0014 14.8158 10.1424 3.95037 3.15478 8.54077 +586 1 6.86541 7.01247 15.582 10.3214 -0.24422 -5.9518 +587 2 7.78025 7.06796 15.2658 -3.95377 -6.01896 -2.62563 +588 2 6.83046 7.729 16.2102 -7.67029 5.21932 8.6005 +589 1 8.00165 4.68416 13.4443 -21.8863 -22.7248 -23.0503 +590 2 7.36443 4.84116 12.7101 7.64348 -4.39085 15.7408 +591 2 8.44337 5.50298 13.5544 13.6077 24.8283 3.95349 +592 1 13.4082 12.1692 14.291 7.74384 0.583631 -6.74495 +593 2 13.3391 11.2097 14.1788 -8.03609 -0.555633 4.00216 +594 2 13.8852 12.4587 13.496 -2.17037 2.06617 1.19415 +595 1 14.784 9.43826 7.28323 -11.1269 12.8929 16.9671 +596 2 15.4951 10.0466 7.55684 1.33033 -10.8665 -8.82607 +597 2 14.017 9.71262 7.81429 7.01149 -4.68319 -9.50468 +598 1 12.6837 17.0142 3.10751 10.9269 -13.9095 9.51878 +599 2 12.9708 17.2813 3.99359 -6.48615 4.53386 -3.20168 +600 2 12.1282 17.7068 2.75827 -7.19321 10.5694 -1.73823 +601 1 1.13983 7.14905 17.429 -19.8537 -0.642492 -7.24746 +602 2 0.229092 6.89189 17.6928 9.24629 12.0374 -0.554306 +603 2 1.04788 7.63326 16.5858 1.73105 -6.23108 5.83737 +604 1 12.8283 5.10796 15.6891 -3.1105 -1.51238 -5.72518 +605 2 13.5351 4.46064 15.5231 -0.330328 2.49365 6.49287 +606 2 13.2544 5.98171 15.6287 1.13166 -7.6156 1.26811 +607 1 2.48175 3.38612 5.07416 -11.4746 -6.3359 16.597 +608 2 1.87059 3.13723 5.824 15.2627 10.0051 -19.3068 +609 2 3.07561 4.08306 5.41325 -9.83136 -1.83582 -2.79497 +610 1 8.32062 11.2204 13.4908 14.3326 -12.3724 2.23055 +611 2 8.41586 10.9603 14.3918 -15.5351 3.38632 26.9235 +612 2 9.1195 10.7822 13.1796 -2.73354 4.12568 -26.6086 +613 1 12.9112 1.40899 13.3219 3.38587 -22.7152 11.6955 +614 2 13.5257 1.21801 12.5994 -2.66679 10.6744 -3.40434 +615 2 12.4724 2.23119 13.1327 -1.22779 13.5514 -6.35015 +616 1 6.39925 13.6301 2.14388 13.7527 -0.778699 -6.56015 +617 2 5.84347 14.0897 2.78318 -1.88549 -3.79567 9.96763 +618 2 7.03431 13.0755 2.63977 -7.58465 4.89894 -0.0461429 +619 1 15.9327 6.56061 12.7538 -0.9836 2.19135 -10.6596 +620 2 16.5146 6.98287 12.103 -5.34808 0.40017 1.48081 +621 2 16.2873 6.8165 13.6112 3.99792 -3.90075 7.11277 +622 1 16.8306 0.705066 9.59578 -7.6122 -1.79623 -7.44488 +623 2 16.785 18.3903 9.75048 3.18156 2.06447 -0.865929 +624 2 16.3719 0.843651 8.74144 5.4764 0.262409 5.10626 +625 1 6.12658 11.6826 8.3633 -3.5227 -13.2845 -7.84739 +626 2 5.19255 11.5559 8.64231 15.2704 -3.4985 -2.63712 +627 2 6.45331 10.8168 8.01189 -8.18375 16.1965 9.35276 +628 1 2.85137 8.68091 0.385463 -5.58051 9.89965 12.0536 +629 2 2.19225 8.31695 18.4611 -2.16592 -25.8024 -20.6889 +630 2 2.2971 9.35613 0.77772 10.4924 10.4953 14.3564 +631 1 10.1291 10.4583 6.52809 -2.44089 1.08082 5.72444 +632 2 10.551 9.78353 7.0828 -0.111445 0.581803 -4.14441 +633 2 10.6952 10.5682 5.75546 0.540532 -2.90301 -3.90698 +634 1 6.75412 15.726 6.57209 -8.13971 -2.30487 -2.02419 +635 2 7.24364 15.9641 7.36655 2.15693 7.18823 -0.87292 +636 2 6.8879 16.4298 5.90744 8.86888 -7.67267 7.00242 +637 1 6.43944 13.0908 5.62507 5.5957 4.80241 6.78236 +638 2 6.68766 13.9873 5.91055 -1.86537 -6.12454 -2.89892 +639 2 6.02344 12.6885 6.39583 0.545895 -2.8305 -0.33431 +640 1 16.7919 12.5477 9.81186 8.33998 7.78307 -15.4118 +641 2 16.959 11.947 9.07064 -2.3739 -7.40637 3.16023 +642 2 17.0566 13.4004 9.43565 -5.48117 -2.43007 10.0621 +643 1 6.08508 2.94496 2.79534 5.32525 -4.78467 20.7365 +644 2 6.22401 3.88181 2.60268 1.06349 -0.160394 -8.38338 +645 2 5.80007 2.47136 2.00522 -4.08992 3.93243 -8.80646 +646 1 10.8869 3.24711 3.28239 -4.40001 1.54122 -3.81905 +647 2 10.3919 4.04182 3.50512 -0.182415 -1.04618 4.274 +648 2 10.507 2.97693 2.43998 1.37333 -6.80979 -0.861155 +ITEM: TIMESTEP +40 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.77679 7.00681 17.9176 19.5781 -11.4355 -6.13067 +2 2 7.88289 7.04978 18.2154 -24.3238 4.20085 7.9494 +3 2 8.82569 6.20257 17.3924 1.80136 1.41546 -3.93969 +4 1 18.6608 8.28849 6.81179 -5.26854 6.47195 -37.0065 +5 2 0.259818 8.10211 5.87223 -9.20216 6.37217 14.1473 +6 2 0.533966 7.65898 7.28863 11.4703 -14.4857 21.9358 +7 1 8.44459 18.6539 6.84319 -15.0888 3.44445 3.75329 +8 2 9.31627 0.207433 6.52222 15.1831 4.47029 -4.67038 +9 2 7.87035 0.688968 6.45696 3.7806 -3.44044 1.26969 +10 1 6.57294 1.78151 11.6706 -30.0599 9.45416 18.0529 +11 2 5.79693 2.24632 12.0928 24.7239 -13.8096 -10.3139 +12 2 6.23894 0.879353 11.5248 3.88204 4.12095 -2.29502 +13 1 7.0611 5.68864 2.39703 8.93877 -14.6422 -9.86735 +14 2 6.49127 6.20844 2.93802 -15.3109 10.2002 23.1803 +15 2 6.88849 6.05122 1.53455 1.63853 6.11013 -15.8751 +16 1 16.2018 10.2111 16.0976 42.0151 -2.30245 8.02011 +17 2 17.1767 10.3828 16.1846 -31.1897 -9.90141 -8.38467 +18 2 15.8087 11.0308 16.3852 -12.3763 9.98735 1.02793 +19 1 10.6387 14.9527 2.33657 9.03987 18.5511 -2.17595 +20 2 10.545 14.5243 3.1949 1.96881 -4.62445 -0.461144 +21 2 11.2262 15.72 2.53493 -10.4825 -13.512 -5.5858 +22 1 17.1607 8.25027 10.5569 -10.4361 3.90862 15.3578 +23 2 16.8456 8.92829 11.1924 -0.168965 -8.85021 -9.39988 +24 2 17.9277 8.63713 10.1294 7.74511 3.00226 -1.55375 +25 1 14.7566 15.8542 16.4215 -9.50848 16.8449 -9.38304 +26 2 13.8265 16.1715 16.4278 14.8795 -5.02546 -3.6071 +27 2 14.9162 15.569 17.3232 -2.48975 -11.4773 7.52297 +28 1 12.1331 13.4103 0.48985 -10.556 -4.43922 -13.5861 +29 2 11.9475 13.3795 18.1761 8.0664 -0.863413 7.07636 +30 2 11.3865 13.8946 0.862316 6.65844 3.98247 10.4433 +31 1 9.29843 5.44761 4.00486 3.37284 8.34248 -28.0116 +32 2 8.80378 5.24143 4.78809 -8.97197 -9.15203 12.3932 +33 2 8.61542 5.51114 3.30134 8.62356 -3.76178 8.99247 +34 1 1.79678 4.17189 11.6321 9.86643 -30.5991 16.8051 +35 2 1.62878 5.09135 11.8205 -3.04918 18.6361 6.49963 +36 2 2.25792 3.77365 12.4221 -11.5809 11.2089 -24.12 +37 1 2.02425 6.80455 8.32417 0.209126 8.78432 0.0974623 +38 2 2.41895 7.33028 9.04952 -2.4595 -11.9319 -6.9206 +39 2 1.91003 5.89259 8.64365 4.06316 7.1017 -1.03524 +40 1 5.41039 4.42866 7.97545 15.1976 -3.31539 14.1613 +41 2 5.46063 3.46886 7.81834 -3.32316 3.28084 -1.43066 +42 2 4.8072 4.83488 7.36206 -13.6118 -1.04066 -17.9483 +43 1 3.27942 2.94296 17.507 14.649 -12.38 -13.2068 +44 2 4.01307 3.22765 16.9192 -12.2988 4.29907 8.19647 +45 2 2.92414 3.72569 17.9407 -4.7152 6.06254 1.98711 +46 1 7.44402 5.32718 6.09908 -2.23439 -3.56175 -18.7368 +47 2 8.08992 5.98284 6.3762 -3.15187 6.11466 20.9447 +48 2 6.88688 5.06352 6.84221 3.51936 -1.39652 7.32666 +49 1 9.78623 6.99393 11.9838 -8.59529 -1.09594 -12.3674 +50 2 10.3445 6.45759 11.4052 1.55365 1.23763 7.43723 +51 2 9.00985 7.18223 11.4209 7.62587 2.79809 7.26056 +52 1 14.0725 3.61727 8.08367 12.8617 -8.18347 36.7285 +53 2 14.0228 4.31343 7.45005 -3.4794 19.1063 -13.5046 +54 2 14.4179 4.02628 8.91908 -9.29791 -10.4076 -21.8094 +55 1 4.59231 17.2384 3.97449 0.493238 3.33808 0.649061 +56 2 5.51414 17.4776 4.03994 12.0557 0.622386 5.90157 +57 2 4.23063 17.8039 3.28947 -7.41249 -4.06804 -9.31956 +58 1 16.4721 16.5989 10.1846 -15.657 14.3962 29.6607 +59 2 15.672 16.8273 10.736 23.5631 -12.0212 -18.4682 +60 2 16.1719 15.9965 9.50314 -9.75188 -3.46964 -7.56259 +61 1 1.98052 4.85246 0.373619 -1.44601 4.98585 -7.77412 +62 2 2.7262 5.17853 0.894803 -2.15831 4.7879 6.78517 +63 2 1.59165 5.65237 -0.0264377 4.8265 -6.05414 -1.09652 +64 1 11.6431 13.3034 16.3099 -7.83069 14.4437 11.7005 +65 2 11.0472 12.5464 16.386 4.77345 -10.1552 -4.34879 +66 2 12.2516 13.1635 15.5747 -3.53477 -7.02177 -5.05796 +67 1 10.1531 11.0326 16.9094 -23.9188 11.6521 -2.01913 +68 2 10.5087 10.1543 16.8125 9.70699 -14.9542 1.17008 +69 2 9.18648 10.9213 16.8155 11.1855 0.742098 0.22461 +70 1 11.7413 17.4552 13.4621 -1.23374 28.315 3.5075 +71 2 12.4767 17.2116 12.8888 0.8966 -9.51431 -5.30227 +72 2 11.7922 18.439 13.4864 2.17346 -17.034 -0.823798 +73 1 6.40572 9.32656 12.214 8.55802 19.8904 20.5686 +74 2 6.90308 8.91303 11.5283 8.82473 -10.1612 -21.9185 +75 2 7.05175 9.94906 12.6124 -18.2049 -7.77814 -0.199089 +76 1 16.2334 12.8098 2.68826 14.0272 -12.5996 -1.63763 +77 2 17.097 13.226 2.50419 -12.4159 2.28924 0.929092 +78 2 15.5495 13.4898 2.7216 0.770652 8.50493 2.13384 +79 1 0.665645 12.593 5.91595 32.2246 4.40393 3.59492 +80 2 0.90587 12.5095 4.99041 5.40697 -3.98614 -5.66175 +81 2 18.3758 12.6087 5.91046 -34.4951 5.63016 -3.48792 +82 1 5.23151 16.431 18.4431 -16.7943 8.81872 -4.95242 +83 2 5.79594 15.7593 18.0508 10.3373 -8.32481 3.89376 +84 2 5.47944 16.6222 0.707356 8.36178 -5.19521 1.40492 +85 1 0.571414 7.67431 4.12619 2.94709 1.59491 -2.60127 +86 2 18.6158 8.07004 3.46977 2.09916 -2.88444 -0.00351913 +87 2 1.46322 7.94524 3.84829 -2.55586 0.342718 0.201417 +88 1 3.11705 8.93424 6.4998 54.1901 -7.8337 2.25484 +89 2 3.7667 8.5317 7.12157 -13.167 10.549 -15.4875 +90 2 2.28764 8.76575 6.88741 -36.769 -1.96533 12.6863 +91 1 7.28047 10.3297 16.2671 12.2744 -1.5589 -10.8048 +92 2 6.65751 10.5384 15.5688 -5.93087 0.719661 3.96859 +93 2 6.78418 10.1979 17.0822 -4.65586 3.14184 2.44827 +94 1 11.1311 1.01006 5.00872 -4.59838 3.25637 13.1063 +95 2 11.104 1.87564 4.56859 3.00456 -5.57579 -4.19999 +96 2 10.7195 0.375584 4.41788 -1.87117 -0.379426 -13.1931 +97 1 4.37947 2.77237 13.219 1.2209 -0.528365 -1.66794 +98 2 4.72737 3.08878 14.0495 2.85744 14.0767 5.60955 +99 2 4.20383 1.85536 13.4394 -3.83295 -12.6961 -6.71285 +100 1 8.38383 10.1509 1.80871 -12.6182 20.2791 -9.41543 +101 2 8.178 10.838 2.47049 7.2019 -6.44506 -5.42193 +102 2 8.73482 9.42727 2.30684 9.9898 -17.6863 11.9989 +103 1 10.4319 1.72481 15.5562 12.4011 -4.85254 7.43664 +104 2 11.3895 1.56158 15.4091 -17.4954 3.73262 -0.131687 +105 2 10.062 2.13812 14.7716 6.37582 -0.463351 -11.2945 +106 1 2.70803 12.8564 7.7877 0.947466 12.6679 0.63847 +107 2 3.18684 13.6562 7.51328 0.350127 -6.04869 0.642024 +108 2 1.99719 12.778 7.13709 0.576803 -6.26493 0.417134 +109 1 3.70343 11.6943 5.19413 20.2082 20.004 0.0632986 +110 2 3.58824 10.8286 5.55511 -6.2763 -16.1433 9.0068 +111 2 3.08304 11.8089 4.48497 -14.3756 -1.22762 -7.56914 +112 1 6.79775 14.44 16.9261 12.4025 3.68508 -3.36544 +113 2 7.76361 14.3574 16.912 -9.58328 3.53086 0.838276 +114 2 6.54478 14.7426 16.0399 -3.94857 -4.38541 1.40645 +115 1 14.2011 14.5459 3.3522 -3.08566 -2.84615 -1.00806 +116 2 13.6596 15.3308 3.14384 3.83224 -9.07839 4.89455 +117 2 13.7292 13.9763 3.99269 1.14293 11.3016 -6.48612 +118 1 8.39096 18.1361 16.0337 -32.316 13.1552 1.22555 +119 2 8.83502 17.3455 16.3332 22.4875 -6.85104 -0.859562 +120 2 8.9267 0.219511 15.6905 18.196 -4.39201 7.01778 +121 1 4.72714 1.63535 4.92703 -26.6842 -20.3158 26.1173 +122 2 3.8064 1.92851 4.99525 4.72714 3.40068 -1.69015 +123 2 5.07003 2.08002 4.18139 17.9323 21.4409 -28.6349 +124 1 14.9964 12.7123 16.4352 -4.22015 -14.1687 -30.4934 +125 2 14.5029 13.21 17.0522 -6.30453 18.4993 32.9687 +126 2 14.3164 12.5754 15.7407 23.1427 -3.84454 1.0347 +127 1 15.7385 18.4508 16.8675 -13.9243 -22.2803 -23.7862 +128 2 16.4074 18.4637 17.529 20.9098 4.79862 21.1737 +129 2 15.5806 17.4953 16.7298 -7.09236 11.271 1.12369 +130 1 1.21817 1.19055 16.5653 11.7565 -7.97186 -17.2906 +131 2 1.96844 1.77109 16.7379 1.96571 4.11248 6.40071 +132 2 0.658106 1.26508 17.3256 -9.62795 7.29392 16.1709 +133 1 18.134 4.50826 15.9251 -3.15057 6.2034 16.9599 +134 2 18.3539 4.06683 15.1192 3.29697 -9.24478 -15.9855 +135 2 0.215105 4.3469 16.5346 0.451532 1.5183 -0.00159427 +136 1 12.2559 16.9635 16.13 9.81693 16.417 -30.969 +137 2 11.5335 16.7255 16.6761 -27.6315 -15.1383 17.2649 +138 2 11.8852 17.008 15.2138 11.4543 -2.176 15.2032 +139 1 16.0072 2.53826 18.0715 2.86853 -7.51147 -8.26075 +140 2 15.4847 3.23875 18.4474 -1.55266 16.6686 8.62869 +141 2 15.8031 2.59593 17.1292 0.710765 -2.58084 -2.04371 +142 1 6.70782 13.8427 10.2201 -0.679857 -3.70625 -19.7607 +143 2 6.50134 13.5235 11.1067 -0.321862 -5.5215 0.0793921 +144 2 6.59662 13.1168 9.5703 -2.40279 4.60459 14.5526 +145 1 10.136 18.3381 2.74267 -18.0567 -22.0341 20.6824 +146 2 10.1719 0.451126 2.17508 1.85432 15.9621 -15.8725 +147 2 9.21984 17.9907 2.65838 20.6262 7.0183 -5.07627 +148 1 3.02443 17.7208 6.1026 17.1013 10.0229 -4.66436 +149 2 2.15568 17.711 5.71196 -13.0363 -3.14036 -7.80794 +150 2 3.59824 17.9918 5.35649 -4.18715 -9.59785 14.6662 +151 1 12.576 16.8948 8.01086 19.6337 5.92584 -6.52436 +152 2 11.8143 16.3513 7.79321 -8.3204 -4.9503 8.18666 +153 2 12.4158 17.4227 8.81259 -8.93553 -1.00079 -7.85288 +154 1 14.8883 15.2954 8.22088 18.3997 -23.9506 8.44323 +155 2 14.185 15.9366 8.136 -10.7922 9.32905 -8.87486 +156 2 15.3949 15.2296 7.38647 -11.857 13.9652 6.76292 +157 1 17.682 18.2494 0.348905 -7.91474 13.422 2.87656 +158 2 18.5411 17.7865 0.321045 -1.05993 10.3639 -2.93184 +159 2 17.7527 0.554981 0.612143 9.7328 -21.6142 -4.56589 +160 1 0.864553 10.4271 1.36107 38.8853 37.5027 -14.379 +161 2 0.108953 9.99831 1.68821 -41.9718 -23.1906 9.82059 +162 2 0.582253 11.2112 0.83245 0.481516 -18.0373 9.72219 +163 1 1.69239 12.2275 3.35367 -4.8948 -13.153 3.57872 +164 2 1.37753 11.4769 2.79371 7.82838 19.3971 -0.83705 +165 2 1.72119 13.0511 2.84994 -1.71551 -5.72989 -9.02345 +166 1 0.593488 17.2339 4.88925 5.54216 -9.27995 13.1842 +167 2 18.6577 17.9974 4.73698 -0.720643 -6.26101 15.0882 +168 2 0.46443 16.7935 5.76992 -5.72363 16.5902 -22.8723 +169 1 1.11371 0.949119 9.43078 -14.7072 -12.8067 -15.4602 +170 2 1.29442 0.455313 10.245 -0.545661 8.99323 2.98013 +171 2 0.250893 0.599212 9.12975 16.3522 9.05079 5.79158 +172 1 16.7438 2.34594 13.2927 -5.57812 -16.9062 26.8121 +173 2 16.8801 2.6271 12.4058 4.66444 4.54161 -27.0891 +174 2 16.4868 1.39796 13.2842 6.06262 14.3342 0.102967 +175 1 2.62374 15.8311 12.1325 -18.0747 14.04 -25.4855 +176 2 3.15014 15.3809 12.7666 13.9506 -11.3972 18.0386 +177 2 3.07511 15.7224 11.2774 1.07994 -2.68321 4.96368 +178 1 16.4243 15.6576 6.03755 15.9104 -4.34147 -2.36376 +179 2 17.3476 15.7161 6.33483 -8.235 -6.85341 4.18965 +180 2 16.3427 16.413 5.44101 -7.92512 0.157724 -1.18513 +181 1 5.79129 5.09168 11.8004 -4.72983 -0.0241771 3.34223 +182 2 5.24592 5.67928 12.3598 8.87085 -1.40185 -4.45321 +183 2 5.33436 4.24005 11.794 -1.89173 5.24027 0.81451 +184 1 15.1611 4.86757 0.757741 -10.8083 7.02962 -6.60621 +185 2 15.185 4.56786 1.66832 -2.59424 -2.50065 9.27943 +186 2 14.3347 5.37902 0.687967 11.9305 -6.73266 -3.44958 +187 1 16.3215 16.3801 2.08305 3.66808 -22.0917 28.3334 +188 2 16.2883 16.7145 3.0131 -8.2177 -1.24054 -23.9705 +189 2 16.5228 17.1161 1.52724 6.03518 21.1991 -10.8898 +190 1 0.258418 4.84833 3.80491 9.83943 -33.1452 17.0376 +191 2 0.435143 5.7654 3.92096 2.60191 31.4745 -0.643169 +192 2 0.932226 4.39489 4.35318 -12.3014 6.6918 -13.6862 +193 1 2.96829 15.0617 15.1396 -6.44278 -4.84309 -5.22724 +194 2 2.79942 14.7982 16.0602 -0.108783 -2.99279 -5.19286 +195 2 2.41643 15.8476 15.0194 7.7594 2.37019 3.88633 +196 1 1.13965 14.6405 9.53256 -35.9747 -40.3241 22.6064 +197 2 2.06314 14.7027 9.49112 43.1319 12.9068 -8.07313 +198 2 1.0594 13.7772 10.0119 -9.44904 20.5678 -15.2205 +199 1 13.5675 16.5961 11.5382 5.93785 -23.7105 -2.52771 +200 2 13.3768 17.2545 10.8786 -7.41053 16.3631 -3.48345 +201 2 13.1856 15.7884 11.1314 1.00946 8.65797 10.7521 +202 1 4.66618 1.4643 0.77663 11.7421 5.19522 -12.5382 +203 2 4.19094 2.00712 0.127209 -4.75679 -3.07286 5.52347 +204 2 4.08138 0.751582 1.04859 -6.60629 -1.36494 5.43578 +205 1 1.44472 18.5589 11.8552 5.89014 -29.5111 2.70443 +206 2 1.28184 0.411827 12.6654 0.0657759 4.1157 4.72514 +207 2 1.66959 17.6355 12.1243 -0.811151 21.0135 -2.36357 +208 1 11.5239 10.1243 4.0099 -6.2394 6.26334 5.03821 +209 2 11.225 10.535 3.18075 6.07738 -4.97061 3.39644 +210 2 12.4891 10.1836 4.01184 1.61922 -2.52467 0.807021 +211 1 8.27885 12.1614 3.71144 8.13123 -6.41358 -26.5436 +212 2 9.10665 12.5897 3.97429 -2.42085 2.52867 6.94663 +213 2 7.68553 12.1691 4.45091 -10.6399 7.25218 24.1014 +214 1 14.4389 4.03262 3.28382 -1.54769 2.04788 0.687462 +215 2 14.9998 3.98927 4.07922 -0.140352 3.9435 -3.93632 +216 2 13.6855 4.60992 3.49399 3.24138 -5.01437 4.30138 +217 1 5.6049 1.66195 7.51556 2.43321 19.3851 -35.7094 +218 2 4.99817 1.05358 7.93111 -11.2062 -8.09843 6.71806 +219 2 5.29033 1.73413 6.56196 15.7086 -7.98236 30.9511 +220 1 17.8679 1.11465 4.8662 -8.84521 -11.3875 -0.414623 +221 2 18.5938 1.34898 4.28573 7.92092 9.45731 -1.66923 +222 2 17.9348 1.63294 5.67672 2.41874 4.31495 -1.38437 +223 1 6.82183 9.41821 4.49596 0.331068 -0.81956 4.69879 +224 2 6.92763 9.68813 5.42975 0.55668 -5.9518 -10.6641 +225 2 7.69076 9.13696 4.17138 2.49623 1.53594 7.84385 +226 1 2.6692 14.9191 1.96889 -13.7427 -15.0981 33.3863 +227 2 3.22272 14.7135 2.75628 -3.53882 5.4164 -17.9931 +228 2 3.23582 15.271 1.30455 16.0902 7.51076 -16.3339 +229 1 17.3236 12.914 13.1856 6.20451 10.459 -3.7314 +230 2 16.5162 13.3803 13.3896 -16.2035 -4.78456 4.03007 +231 2 17.8657 13.6659 12.9192 5.22743 -7.26423 -1.93052 +232 1 14.957 10.5619 1.40158 33.4378 15.8576 14.4167 +233 2 15.5687 11.2535 1.77718 -16.3935 -17.8486 -10.6273 +234 2 14.0947 10.9454 1.47451 -15.7071 3.57407 -1.68856 +235 1 5.70225 6.80052 4.56184 6.57688 14.9147 -7.26545 +236 2 6.13296 7.68472 4.64206 -12.0226 -12.483 -2.28626 +237 2 6.28869 6.17268 5.00191 2.5554 2.13057 5.94298 +238 1 8.01258 8.29623 10.2593 -8.54796 -9.21297 9.02749 +239 2 8.56841 9.06789 10.0886 3.62647 -1.62136 -15.6888 +240 2 7.62542 7.94814 9.4343 7.03713 6.69092 4.95874 +241 1 13.441 18.4149 5.75957 4.19405 2.302 -13.2138 +242 2 12.6243 0.255994 5.52243 8.89948 -2.22339 5.88848 +243 2 13.1991 17.7887 6.44621 -5.69407 0.108635 9.70575 +244 1 0.157493 2.61527 0.174457 -9.01339 -22.8294 -0.321401 +245 2 17.938 2.88173 18.4446 6.58659 5.28303 7.29983 +246 2 0.732894 3.35773 0.380844 -2.17088 12.8237 -3.11298 +247 1 12.7457 11.0391 9.7485 36.4778 -29.6492 25.4167 +248 2 11.881 10.9734 9.40839 -39.1103 -1.43989 -11.0388 +249 2 12.9187 10.1217 10.0968 -0.290925 20.2268 -9.99681 +250 1 0.740308 12.1745 11.0603 -22.9837 8.27774 -1.01284 +251 2 18.4139 12.2368 11.1424 7.83285 -3.43363 -6.48653 +252 2 1.04445 12.5328 11.8929 13.1768 -0.7817 9.81141 +253 1 5.09631 7.29496 13.4329 -5.02176 -6.40528 2.12919 +254 2 5.65923 7.87015 12.9013 0.281799 7.42737 5.37855 +255 2 5.54275 7.21467 14.2893 3.22018 -2.41867 -5.38403 +256 1 1.21307 6.88521 11.8471 45.2055 23.2855 19.4361 +257 2 0.504281 7.33909 11.418 -17.6401 7.5893 -9.966 +258 2 1.85566 7.62216 12.1147 -28.9146 -29.9066 -6.84092 +259 1 15.4951 9.58282 12.318 3.7565 -9.08444 -2.54037 +260 2 14.9885 10.3731 12.1762 -1.60608 19.4691 -5.65324 +261 2 15.197 9.26603 13.1641 1.66558 -4.92983 10.8479 +262 1 16.5876 12.7654 5.4778 8.29992 -4.99789 29.9812 +263 2 16.3841 13.7077 5.58453 -1.61151 1.51391 -8.42869 +264 2 16.4534 12.5134 4.57091 -6.79319 5.2662 -20.9737 +265 1 6.24519 9.93185 0.0511849 19.8307 -8.34124 26.5163 +266 2 5.62326 10.391 0.623031 -8.96333 4.37615 -1.09153 +267 2 7.04636 9.86115 0.632167 -14.2701 4.68407 -14.2447 +268 1 12.3094 6.10151 4.07154 29.4526 9.60181 -18.9544 +269 2 12.3581 6.67925 3.27122 -7.72489 -2.14158 19.4346 +270 2 11.4533 5.70734 4.07903 -24.5921 -5.49884 -2.8127 +271 1 0.238725 12.7856 0.183979 8.51406 3.08383 0.253195 +272 2 0.144933 13.4932 0.833619 -6.86037 1.22763 2.8825 +273 2 18.4214 13.096 18.0418 -3.66036 2.31192 -5.9902 +274 1 3.70956 18.598 8.57987 -8.91795 8.796 11.4474 +275 2 3.55449 18.0356 7.80833 -3.96611 6.10323 -0.149317 +276 2 2.8446 0.378518 8.78385 11.2365 -8.2841 -4.38951 +277 1 7.48876 17.3305 4.49636 -9.17434 -25.7083 -0.449464 +278 2 7.67261 18.2518 4.49855 7.01126 32.4538 5.60223 +279 2 7.56532 17.0943 3.57389 -1.71949 -1.63571 -7.00131 +280 1 9.24209 17.1007 12.2607 -0.0867103 -4.31389 -13.5747 +281 2 9.30622 16.4126 11.5797 -4.40084 -0.983353 3.37399 +282 2 10.1228 17.1279 12.6444 4.44927 1.46684 7.86514 +283 1 13.3362 12.9421 7.98122 6.55916 41.1429 -16.6734 +284 2 13.3796 12.1892 8.55526 4.57885 -11.5398 14.8452 +285 2 13.9495 13.647 8.31623 -8.21726 -16.9651 -6.13203 +286 1 14.9343 2.98184 15.3399 -18.8859 -3.08059 15.3623 +287 2 14.3306 2.22694 15.2091 8.05839 6.56319 -1.64083 +288 2 15.5611 2.99492 14.6188 6.00199 -3.60128 -9.94013 +289 1 9.8611 15.5568 16.9864 -5.18568 1.15062 7.50023 +290 2 10.3014 14.7282 16.7357 2.8278 3.85059 0.776615 +291 2 9.42894 15.4199 17.8518 3.24739 -0.30663 -9.25648 +292 1 11.3089 8.34774 16.5637 -8.99518 -4.25182 3.40254 +293 2 10.6351 7.93491 15.9913 5.93093 -1.15278 9.90769 +294 2 11.3777 7.78039 17.3602 -0.876032 6.75541 -11.8921 +295 1 3.86263 18.1743 16.7605 8.31608 -24.0238 3.67333 +296 2 4.34809 17.526 17.3016 -5.03788 -1.4921 -11.4176 +297 2 3.91859 0.291346 17.3034 -3.84782 28.4328 8.21839 +298 1 2.18675 4.1526 8.92206 -24.1698 7.19476 -17.4672 +299 2 3.08777 4.02084 8.66345 19.2563 -3.88604 2.84364 +300 2 2.11989 4.14607 9.87269 6.11123 -7.11558 17.6044 +301 1 9.878 10.3743 9.69372 5.53967 -18.4491 14.0185 +302 2 9.43572 11.1423 9.3425 -1.35277 14.796 -0.820696 +303 2 10.0526 10.4842 10.6451 0.294207 2.81912 -6.3598 +304 1 9.67606 0.861397 10.8616 12.1631 -0.119776 7.34561 +305 2 9.24662 0.0503119 11.2005 -2.60905 7.79605 -9.27605 +306 2 9.17358 1.27941 10.1433 -7.66403 -7.87567 2.43043 +307 1 9.19351 15.1133 10.2188 11.11 2.94282 0.236533 +308 2 8.72034 15.7288 9.64731 -2.95318 7.0206 -0.021652 +309 2 8.61234 14.3559 10.3013 -9.273 -0.749783 0.810803 +310 1 0.983709 9.49699 10.2982 -74.1988 19.4185 4.2569 +311 2 0.893433 10.4494 10.5162 13.7438 -13.7231 -2.84852 +312 2 1.86549 9.26486 10.2468 58.3196 -6.52918 -3.90093 +313 1 16.9084 4.83943 8.1598 4.06942 21.6595 -28.8412 +314 2 16.3724 5.61591 8.36865 -1.41178 -4.09344 3.51719 +315 2 16.8393 4.26054 8.89216 -0.699807 -17.3102 23.1105 +316 1 14.7125 14.7098 0.257213 21.3866 7.73012 -2.74727 +317 2 15.2455 15.0698 0.987096 -5.24332 1.02996 -2.3964 +318 2 13.934 14.3364 0.654485 -15.8904 -6.61515 6.72623 +319 1 3.61962 11.0361 9.55343 7.54802 -1.42323 12.4812 +320 2 3.62776 11.3571 10.4773 -0.544226 1.54555 -6.56144 +321 2 3.18313 11.7186 9.01674 -3.18494 -0.813089 -1.4949 +322 1 11.1481 10.7794 1.3867 -18.0125 -13.9714 2.13506 +323 2 11.5419 11.6189 1.17487 5.50703 16.2749 -10.1623 +324 2 10.2377 10.7815 1.02242 13.9743 0.382042 6.15217 +325 1 13.1644 7.14571 12.7934 28.1674 11.2254 -0.0108115 +326 2 14.1505 7.05998 12.7803 -16.3048 -3.53009 2.57838 +327 2 12.835 6.25234 12.9024 -6.40061 -9.363 -1.95696 +328 1 9.62034 1.87073 0.979069 -6.9897 -0.645983 -14.1021 +329 2 8.86926 1.41829 0.528843 9.90899 13.9476 5.87182 +330 2 10.1257 2.37739 0.312436 -3.40486 -11.198 4.68953 +331 1 10.6367 13.5403 4.62088 -14.2461 -11.7796 -9.34504 +332 2 11.3649 12.9086 4.64313 9.4379 4.41524 3.81629 +333 2 10.614 13.9519 5.48444 4.98914 7.07 10.6976 +334 1 14.3951 1.77229 10.9373 11.882 -13.8992 0.14286 +335 2 15.2529 1.46692 10.5904 -8.80209 -5.09491 0.192719 +336 2 14.4998 2.72321 10.9422 -3.89457 8.74507 -1.42899 +337 1 14.6035 12.2778 11.6732 8.28457 -2.47972 34.5189 +338 2 15.3822 12.4706 11.1386 -1.8445 -1.29245 -12.2333 +339 2 13.8238 12.1274 11.1597 -9.6117 -2.29221 -24.4043 +340 1 8.21682 5.05944 9.82725 33.2235 -12.7421 -22.1109 +341 2 7.50249 5.31613 10.3805 -26.8995 -2.6371 14.604 +342 2 8.16278 4.09579 9.61432 -6.39419 19.305 4.57693 +343 1 1.57178 16.8746 18.3696 -12.5949 -28.7752 19.8992 +344 2 1.95856 17.2997 17.6256 12.4489 12.7929 -23.944 +345 2 1.61191 15.9133 18.1414 3.74732 18.7705 7.54273 +346 1 1.50483 17.2622 15.3369 -31.2805 -0.211241 0.372367 +347 2 1.56428 18.1715 15.7008 -8.02099 -13.4799 -3.86937 +348 2 0.550545 16.944 15.3287 29.8388 16.9503 2.40621 +349 1 3.67189 5.70682 6.10259 2.52977 5.35962 -6.45813 +350 2 3.10512 6.24939 6.65687 -5.8484 1.84291 7.09291 +351 2 4.11645 6.33532 5.504 1.86189 -8.61654 4.18176 +352 1 12.4205 9.46682 14.1922 0.00765934 6.29699 5.01976 +353 2 12.7713 8.66673 13.7826 1.27338 -5.49384 -0.333278 +354 2 12.2037 9.20626 15.0998 2.51081 -2.42178 -0.168732 +355 1 4.04257 15.2822 6.8914 -27.6779 4.92775 8.06061 +356 2 3.56316 16.0906 6.63798 2.42102 -8.57509 -1.16647 +357 2 4.95231 15.5118 6.77617 25.3206 1.78005 -4.31003 +358 1 0.630616 8.59357 14.9621 0.0534875 13.3347 6.63524 +359 2 0.475879 9.54739 15.0951 0.802494 -5.58418 -0.636111 +360 2 1.32488 8.5708 14.2996 4.58301 -1.27906 -6.75903 +361 1 12.9988 8.28033 10.3217 -21.3611 19.4324 1.5895 +362 2 13.6573 7.74741 9.88515 12.8548 -10.016 -2.83384 +363 2 12.9714 7.9897 11.246 0.968107 -4.04745 -5.09921 +364 1 15.3184 7.7322 3.54707 4.18654 -9.90345 10.9868 +365 2 14.6375 7.17364 3.22195 -21.9236 0.488691 -25.4272 +366 2 15.542 7.2045 4.31452 16.9904 15.0521 14.7627 +367 1 17.298 6.68564 0.0426033 13.9193 -14.0885 -0.920406 +368 2 16.8642 5.82471 0.139777 0.0396094 5.05794 2.76644 +369 2 16.6003 7.28204 18.4358 -17.9105 11.3609 -4.38582 +370 1 8.85442 6.93876 7.83202 25.5204 20.9839 -12.9835 +371 2 9.78415 7.28149 7.87459 -21.3181 -5.86923 -3.23496 +372 2 8.81067 6.25344 8.49096 -5.61401 -13.4392 14.4413 +373 1 12.3763 0.596552 1.22002 -1.17453 2.99561 6.82033 +374 2 13.3385 0.528874 1.30915 -5.26207 -0.953155 0.827968 +375 2 12.0852 0.273415 0.369127 5.54968 -2.26078 -4.64309 +376 1 5.63283 15.1348 14.5573 -11.4131 -7.08845 -3.56826 +377 2 4.66833 15.2302 14.6984 9.61439 -4.03287 3.27369 +378 2 5.92452 15.9751 14.1944 7.77409 8.39082 -1.96781 +379 1 3.86657 6.44559 1.75085 5.80409 -14.6499 1.98717 +380 2 3.55249 7.31671 1.4889 -5.45171 9.45984 0.647045 +381 2 4.14269 6.4981 2.68117 -5.39897 6.08822 -6.8935 +382 1 3.91507 11.6157 12.3486 -13.4135 -1.42429 5.74998 +383 2 4.7693 12.0145 12.538 6.44699 -0.479912 -1.2837 +384 2 3.27735 12.1325 12.8813 7.77399 -7.15276 -11.5357 +385 1 5.36262 3.86651 15.8768 12.1389 -59.3419 -3.52329 +386 2 6.1064 3.19888 15.7551 -26.8485 22.8054 1.66706 +387 2 5.75212 4.71249 15.8089 15.627 34.646 -1.2618 +388 1 14.3819 10.2457 4.44716 -17.5064 5.46907 41.0935 +389 2 14.5449 9.71992 5.26671 -1.94493 10.8322 -14.5796 +390 2 14.8723 9.82528 3.76702 14.2142 -16.5996 -23.0963 +391 1 7.82031 17.402 9.18196 15.4978 -20.6961 5.52716 +392 2 6.95708 17.6159 9.5372 -6.73409 6.75657 -1.79958 +393 2 8.0438 17.9374 8.41052 -8.48575 5.6988 -1.01071 +394 1 4.52697 14.5011 3.99561 -1.64824 1.80571 -15.4173 +395 2 4.43911 15.4257 4.28139 2.0309 -4.99506 3.13673 +396 2 4.3827 13.9072 4.73582 -0.0495062 -0.930109 11.2178 +397 1 14.2192 7.41869 15.785 -17.5888 -3.59777 -10.979 +398 2 15.1626 7.35697 15.6947 20.631 -1.7403 -3.62609 +399 2 14.073 7.80524 16.6426 0.667235 5.42077 11.7037 +400 1 2.9565 18.2605 1.91108 1.19197 -18.909 -26.3864 +401 2 2.43337 17.7432 1.2423 11.354 8.34367 16.4878 +402 2 2.37308 0.276014 2.2689 -15.3488 13.3111 9.03739 +403 1 8.00359 1.60253 4.55907 -38.5212 -7.91491 7.83452 +404 2 7.38229 2.10405 3.99193 12.1921 -3.74558 1.60605 +405 2 8.88232 1.74243 4.26439 24.0023 10.0694 -13.3902 +406 1 2.4736 14.1336 17.6839 19.5549 7.85258 6.07398 +407 2 1.90347 13.5339 18.1719 -6.00167 -6.95039 -0.586477 +408 2 3.38553 13.9045 17.9683 -9.72011 -2.72883 -0.373401 +409 1 0.820064 1.73894 13.8888 -18.5285 5.33114 2.4032 +410 2 0.803771 1.49328 14.8397 -2.66487 6.43341 -16.8821 +411 2 18.5531 2.02517 13.6233 21.0072 -9.49287 13.5993 +412 1 4.44957 0.0409644 13.9204 -25.6038 8.03756 8.31677 +413 2 5.34611 18.3721 13.8825 17.1601 -8.5878 1.82821 +414 2 4.09536 18.4705 14.8092 8.9848 -0.155186 -10.4675 +415 1 7.11939 0.665063 18.3496 37.4596 -16.3367 -22.9959 +416 2 7.39046 0.248229 17.4868 -7.59422 10.3961 22.0522 +417 2 6.17976 0.73857 18.3349 -24.6121 7.91301 3.99406 +418 1 16.0679 18.4255 14.0033 46.948 4.07246 14.5496 +419 2 15.1925 18.2569 13.7481 -41.7006 -8.82757 -2.39817 +420 2 16.1514 18.46 14.9783 -11.5795 5.15321 -10.1321 +421 1 10.0899 4.51466 16.2755 46.1692 31.6348 -9.79269 +422 2 11.0262 4.80528 16.0633 -26.3332 -3.27592 13.4521 +423 2 10.217 3.58436 16.3451 -11.2214 -29.3564 0.661634 +424 1 15.916 17.7977 4.41903 32.6965 1.49817 -6.30174 +425 2 16.457 -0.0326327 4.45612 -4.70593 -7.03645 1.74937 +426 2 15.0663 18.0576 4.73092 -30.5769 8.16516 8.13282 +427 1 7.01211 17.4116 13.808 -11.1093 -0.0306798 -7.53718 +428 2 7.48321 17.731 14.5797 1.71822 -1.35338 6.01299 +429 2 7.70771 17.2257 13.1599 -0.832239 2.47859 1.40448 +430 1 13.2731 6.49483 6.63036 5.49864 12.0855 21.8831 +431 2 14.0036 7.1367 6.53142 -6.95912 -13.4785 -6.50558 +432 2 12.9191 6.26998 5.7719 1.78547 5.07661 -13.1828 +433 1 7.78873 2.35817 9.26787 13.6578 7.92928 32.9359 +434 2 7.26595 2.28464 10.098 4.41261 -4.66671 -14.4408 +435 2 7.24114 2.08424 8.54668 -18.4281 -7.28868 -15.4379 +436 1 15.1807 14.8213 13.6836 12.0158 -14.5979 1.51453 +437 2 15.023 15.1631 14.5679 -5.44227 3.64048 5.06686 +438 2 14.7818 15.3898 13.0312 -8.03448 9.52233 -3.65179 +439 1 9.37687 8.31604 3.76928 5.34304 4.19186 5.02399 +440 2 10.2244 8.59911 4.15846 -6.46746 6.21109 -7.45595 +441 2 9.38739 7.36131 3.86692 -0.369722 -6.10407 -0.56198 +442 1 17.7826 13.5587 16.3931 -18.259 -13.3606 7.93732 +443 2 16.8564 13.2543 16.3515 3.23179 3.05811 2.18424 +444 2 17.7493 14.412 15.956 6.45918 8.6709 -4.68033 +445 1 4.96945 10.6182 2.7671 -20.0352 21.3698 -14.9929 +446 2 5.67156 10.2863 3.30832 14.7689 -7.42384 15.9186 +447 2 4.73305 11.5 3.12196 4.54065 -18.1741 -2.81522 +448 1 3.75186 8.34553 10.1595 -2.54049 11.5371 -18.7835 +449 2 3.83158 9.28658 9.87851 -1.62744 -10.9109 6.60301 +450 2 3.69687 8.33176 11.111 2.12623 4.07512 13.0596 +451 1 16.0105 7.02075 6.14683 -8.93467 17.9282 -2.69417 +452 2 16.8191 7.42843 6.45697 9.04966 6.41713 2.22097 +453 2 16.1641 6.09023 6.1704 3.21598 -21.4167 -2.94797 +454 1 15.1148 7.07457 9.06702 4.51295 -11.3361 21.5265 +455 2 15.7278 7.43111 9.72685 3.64545 -0.886375 -6.04752 +456 2 15.1684 7.6713 8.33808 0.281889 14.352 -20.2518 +457 1 6.32562 13.0044 12.7823 3.64263 -12.4915 -10.2251 +458 2 7.18031 12.5985 13.0233 -9.44077 2.88231 5.28619 +459 2 6.10277 13.6925 13.4113 4.07235 10.5841 12.4872 +460 1 12.13 4.50388 13.0978 -23.9143 -18.2098 -29.5576 +461 2 12.2018 4.66005 14.0386 -4.52664 -3.61945 12.4396 +462 2 11.31 3.95423 12.8708 29.5104 21.9629 17.7949 +463 1 11.3628 8.1671 7.89263 -5.63688 4.26156 -3.21905 +464 2 12.0486 7.63378 7.48497 5.26632 -9.68169 -9.18733 +465 2 11.6596 8.25059 8.79652 3.08614 3.11673 13.4283 +466 1 17.1728 10.8467 7.48683 -9.78257 9.61375 -3.53187 +467 2 17.8082 10.1926 7.21604 13.2987 -16.4259 3.23364 +468 2 17.1151 11.4269 6.71399 -11.2446 1.98681 4.69156 +469 1 5.26156 18.1118 11.0164 11.279 0.780011 3.76881 +470 2 4.63029 17.9037 11.706 -3.79608 -1.61163 6.00067 +471 2 4.75114 18.4846 10.3039 -10.5863 -2.03901 -14.6626 +472 1 7.60927 17.5116 1.80376 -12.2084 0.332405 -16.0787 +473 2 7.73547 16.6894 1.27511 4.49641 20.7738 7.60921 +474 2 7.29137 18.2078 1.17993 10.7818 -15.1152 7.96202 +475 1 1.93242 12.9038 13.5907 -11.1009 -8.62515 -2.91716 +476 2 1.44204 12.3193 14.1878 -0.742257 0.132846 -0.79095 +477 2 2.14259 13.6778 14.1103 6.96653 11.7909 8.84583 +478 1 9.6349 6.79099 14.8483 -7.90933 -4.5792 7.57822 +479 2 9.76837 5.84646 15.0736 0.917781 12.494 -4.6794 +480 2 9.97866 6.97841 13.9703 0.736717 -7.57275 -8.26148 +481 1 15.2733 4.3257 10.7584 -18.0594 -0.89979 -6.45033 +482 2 16.1458 3.96681 10.9687 3.533 12.3702 4.36819 +483 2 14.9475 4.94569 11.4317 15.7147 -3.56113 0.605423 +484 1 11.2438 6.16931 0.179082 0.0277951 -2.16566 -3.90965 +485 2 11.3357 5.30361 18.4317 14.8036 -12.0621 -1.88578 +486 2 10.2956 6.2638 0.1816 -11.5861 14.503 2.02073 +487 1 0.0439986 11.3816 15.0585 -6.49496 4.09431 2.20477 +488 2 18.034 11.5578 14.353 7.75523 3.54925 4.26198 +489 2 -0.111373 12.1024 15.7029 3.25408 -7.01329 -10.5532 +490 1 7.06114 9.23722 7.26386 23.5376 12.3273 -0.106793 +491 2 6.50127 8.56776 7.63843 -10.2441 -19.5548 5.03643 +492 2 7.97426 8.90952 7.38371 -13.166 2.65106 -3.29749 +493 1 18.3483 15.3728 12.3401 -6.10947 1.64082 -0.490965 +494 2 0.640544 15.4003 12.1341 13.3619 2.30286 0.418231 +495 2 17.9315 15.8707 11.6253 -4.70162 -1.66258 -3.35097 +496 1 16.5284 4.37134 5.23872 23.865 15.8443 -24.0922 +497 2 16.795 4.23475 6.13242 -1.17196 -10.8972 27.7735 +498 2 17.3848 4.63349 4.80865 -25.3878 -11.1359 -1.24016 +499 1 17.7266 3.13043 10.7284 -15.1505 -16.4799 -4.03799 +500 2 -0.0205156 3.31599 11.0266 10.8372 -1.61224 -0.261482 +501 2 17.686 2.21262 10.3629 5.98361 15.5222 5.29053 +502 1 12.2768 0.00077952 10.1229 -5.39949 -11.0736 -0.564535 +503 2 11.3994 0.337416 10.3512 -3.44242 -0.519791 1.58275 +504 2 12.8621 0.740723 10.2534 12.1364 13.942 1.61795 +505 1 10.3933 9.78571 12.4371 -17.696 -6.66554 -9.33286 +506 2 11.04 9.8019 13.1479 9.02187 0.111511 2.28178 +507 2 10.1583 8.84624 12.3274 6.95171 5.58218 -0.582165 +508 1 0.583846 2.83323 7.01904 8.81732 -31.8654 7.83245 +509 2 0.599611 3.49885 7.68934 -3.58556 22.6003 9.07619 +510 2 0.952398 2.07883 7.51841 -6.10214 6.37924 -11.0018 +511 1 0.367433 15.2949 6.92522 -4.7012 3.61818 34.4112 +512 2 0.558547 14.7156 7.70153 -1.71176 22.246 -5.06421 +513 2 0.60814 14.7658 6.19753 10.4713 -26.0103 -27.8181 +514 1 17.0409 7.00624 15.2099 -22.5014 1.92016 -1.24665 +515 2 17.7387 7.65639 15.0691 10.2085 -5.07189 3.59706 +516 2 17.3996 6.21947 15.6455 8.09739 1.82665 -3.45815 +517 1 9.08645 12.4582 8.07298 60.2845 4.68897 0.226728 +518 2 9.45122 11.8173 7.41895 -17.2892 5.38378 7.41181 +519 2 8.16079 12.445 8.11596 -46.4448 -7.25102 -10.4423 +520 1 1.26434 1.84534 2.97351 6.14985 -4.32801 10.6126 +521 2 0.602074 2.03133 2.30849 -1.31532 11.5451 -8.74279 +522 2 1.61884 2.681 3.33622 -3.80121 -10.2767 -5.51985 +523 1 4.10472 15.1163 9.79145 -1.9934 -0.675971 8.59173 +524 2 4.064 15.4281 8.88095 5.53492 -3.39313 -4.80569 +525 2 4.98866 14.7298 9.93327 -5.1567 4.83883 -4.62826 +526 1 7.25259 2.18349 14.6213 0.0617677 -13.2081 -4.74626 +527 2 7.15489 1.70536 13.7831 -3.1697 0.657011 7.79217 +528 2 7.60954 3.02479 14.3607 5.63067 15.2107 -2.58221 +529 1 18.5424 14.6505 2.1789 -18.2195 12.8357 -3.23587 +530 2 0.746704 15.0923 2.14855 14.3998 1.01071 2.70778 +531 2 17.888 15.3836 2.15154 2.4051 -14.4939 -0.146303 +532 1 9.96619 2.7451 12.9133 2.94451 10.1866 18.8487 +533 2 9.87163 2.03702 12.2777 -5.79326 -7.02869 -14.8001 +534 2 9.15272 3.27293 12.9211 3.46257 -1.15836 -6.04557 +535 1 2.89008 8.93457 13.069 -0.378913 -4.03455 -0.489948 +536 2 3.23396 9.82093 12.8894 1.3587 3.50504 -2.14294 +537 2 3.63423 8.44035 13.4383 1.00579 -2.11175 -2.13579 +538 1 3.23705 8.4538 3.70316 6.66602 15.0067 -51.1451 +539 2 3.68898 9.21355 3.2191 -13.1992 -22.9024 22.1933 +540 2 3.37321 8.55056 4.62635 6.35333 11.1623 30.2444 +541 1 5.63533 7.19464 8.56829 15.13 5.19196 -11.3333 +542 2 5.75579 6.23215 8.63413 -6.09463 5.83127 4.58457 +543 2 5.06463 7.50349 9.27803 -5.30623 -7.19668 4.50769 +544 1 14.8805 1.37043 1.98087 -12.9306 20.6627 -0.801435 +545 2 14.4834 2.20569 2.28334 5.69168 -11.9007 13.5915 +546 2 15.1168 1.59638 1.09054 15.1066 -6.121 -14.4277 +547 1 8.35206 15.1867 0.801551 -2.76223 -14.7585 -5.29804 +548 2 9.12264 14.9643 1.32951 11.031 8.33032 8.58299 +549 2 7.67017 14.6008 1.15941 -5.63761 -0.337967 -3.00039 +550 1 15.5896 1.3528 7.2086 5.32958 13.3681 13.2076 +551 2 15.0272 0.817571 6.66531 -11.4451 -13.4108 -9.89715 +552 2 14.9993 2.0562 7.52457 4.21653 3.3566 -1.64766 +553 1 5.02591 13.0452 18.4884 -9.20414 -3.59717 -21.6247 +554 2 5.46138 13.1397 0.681872 7.63488 2.92653 16.7381 +555 2 5.72796 13.1696 17.8326 -7.15584 3.38504 4.08457 +556 1 15.3795 8.51367 18.1423 -0.613664 -0.0581633 13.6311 +557 2 15.7206 8.99589 17.3938 3.47957 9.7554 -12.9134 +558 2 15.3333 9.18442 0.205917 -4.60531 -6.1888 -2.54679 +559 1 12.0939 3.05244 18.336 -15.98 21.6351 4.66001 +560 2 12.5019 2.66242 0.476891 0.147771 -8.75739 -8.71627 +561 2 12.3559 2.60872 17.5248 9.46456 -12.7769 5.34739 +562 1 13.1875 12.6757 5.16147 -9.52799 6.20775 -2.46737 +563 2 13.6969 11.8811 4.95337 3.5398 -1.69434 3.58065 +564 2 13.2525 12.8475 6.11376 6.90446 -8.64397 -1.04625 +565 1 6.03627 7.1613 0.0926319 -1.4976 11.1377 0.14104 +566 2 5.76921 8.10211 0.154014 9.70457 -9.32393 -3.08293 +567 2 5.20613 6.68485 0.159604 -1.55619 -3.41243 3.21991 +568 1 17.685 15.9184 14.9825 -1.37425 0.537856 -17.3926 +569 2 16.8502 16.3506 14.966 -20.4161 12.6054 20.7942 +570 2 17.7239 15.7506 14.0369 24.1644 -10.6132 -5.26117 +571 1 13.1805 0.948047 16.6125 -8.26177 1.73564 3.5107 +572 2 14.0455 0.715926 16.9626 7.25254 0.595142 -3.17693 +573 2 12.7267 0.0993777 16.5408 2.533 -1.4889 -4.3323 +574 1 11.0204 14.5878 7.33132 -13.7805 -25.7938 -0.586216 +575 2 10.2983 13.987 7.62969 9.87943 15.8321 -1.01987 +576 2 11.8217 14.058 7.45361 -0.254224 3.6388 3.5388 +577 1 17.5119 8.53957 2.08465 9.75653 -12.9638 -10.6953 +578 2 16.6633 8.36471 2.52368 3.0717 -2.74041 -4.8374 +579 2 17.6343 7.8268 1.40004 -7.84255 17.4574 20.9547 +580 1 12.3495 7.93856 1.97915 15.2682 -24.1922 3.95646 +581 2 11.8245 8.73298 1.97607 -8.33179 10.3297 -5.28986 +582 2 12.0289 7.32679 1.29658 -2.64171 9.95394 1.06163 +583 1 11.9622 14.6462 10.3592 5.19436 44.1652 25.6085 +584 2 12.1561 13.8266 9.98193 3.67183 -41.4058 -22.2867 +585 2 11.0169 14.8072 10.2884 -7.2612 -3.28322 -4.25289 +586 1 6.85285 6.99572 15.5659 -14.0155 -24.0568 -12.8099 +587 2 7.75988 6.91015 15.2685 9.48733 7.04308 1.07731 +588 2 6.80041 7.76332 16.11 4.63477 18.9896 15.1539 +589 1 8.01222 4.65145 13.4113 -36.8067 -34.3033 -31.6859 +590 2 7.3316 4.83402 12.7007 16.1602 -3.60309 24.697 +591 2 8.38377 5.47541 13.6286 15.6027 34.5994 6.21753 +592 1 13.4241 12.174 14.3057 -4.84328 6.02619 2.2323 +593 2 13.1628 11.2453 14.2138 0.984992 -0.986947 -4.38535 +594 2 13.8661 12.446 13.4834 -0.550032 -4.72607 1.54363 +595 1 14.7341 9.44221 7.2791 -5.07947 3.15833 13.2143 +596 2 15.5444 9.94699 7.52972 -16.5583 -4.09464 -2.76463 +597 2 13.9842 9.66778 7.87655 21.0159 1.38057 -11.435 +598 1 12.706 16.9897 3.14089 12.6698 -33.6085 3.29803 +599 2 12.7844 17.2146 4.05845 5.40916 5.57996 15.4808 +600 2 12.1668 17.6603 2.78193 -20.8699 29.0634 -19.4792 +601 1 1.09001 7.14262 17.4001 -13.5934 2.13623 7.48936 +602 2 0.156991 7.24832 17.6908 14.7769 -7.58529 -2.77652 +603 2 1.13731 7.55625 16.5284 -2.3111 1.37932 -0.487878 +604 1 12.8562 5.06495 15.6988 -8.68567 -0.702669 -5.76624 +605 2 13.5471 4.4122 15.5538 8.1837 -6.12965 4.55719 +606 2 13.3218 5.91347 15.6395 -0.893164 2.09785 3.54679 +607 1 2.45402 3.36746 5.11563 -15.0026 -7.91555 0.636238 +608 2 1.84292 3.24382 5.86687 4.72922 -2.7794 -8.95345 +609 2 2.91216 4.18226 5.3072 9.55717 10.9124 5.44962 +610 1 8.31869 11.1649 13.5414 -26.3953 31.2189 -67.0184 +611 2 8.3305 10.9362 14.4299 14.6498 -23.9054 54.2316 +612 2 8.96182 10.7076 12.9898 15.0794 -7.45176 14.931 +613 1 12.9219 1.43726 13.3082 8.40674 -27.4269 12.3988 +614 2 13.6356 1.33586 12.6838 7.08718 -5.3 -10.143 +615 2 12.6036 2.28403 13.0872 -17.61 33.9058 -2.44667 +616 1 6.45277 13.6094 2.15178 17.7292 -13.553 0.669437 +617 2 5.88225 13.9257 2.84987 -12.2826 9.62032 8.12495 +618 2 7.05696 13.0019 2.62135 -3.25561 7.9246 -7.28354 +619 1 15.9319 6.53462 12.7261 -1.3149 8.22476 -13.019 +620 2 16.4256 7.00237 12.02 -4.18033 -7.18445 13.3481 +621 2 16.3662 6.74364 13.5705 0.249391 -3.37031 -2.78146 +622 1 16.8119 0.703827 9.59317 0.0549178 13.2549 -11.7388 +623 2 16.9772 18.4048 9.65541 -4.88295 -11.6626 5.05601 +624 2 16.4803 0.847119 8.68154 -1.08178 -1.2883 7.79904 +625 1 6.11652 11.6489 8.33522 -7.45125 2.78057 4.10213 +626 2 5.22601 11.4682 8.68918 7.08294 1.77705 -0.544493 +627 2 6.44454 10.7788 8.07724 4.19277 0.895061 -4.04259 +628 1 2.82334 8.71064 0.367814 57.5944 7.33247 25.2144 +629 2 2.2601 8.16366 18.5098 -36.527 -13.587 -20.7071 +630 2 2.37171 9.41868 0.829256 -17.9324 0.137834 -3.43482 +631 1 10.1122 10.4601 6.54653 2.23323 -6.08635 8.59596 +632 2 10.5188 9.74717 7.06727 -1.60105 2.20328 -1.71973 +633 2 10.6949 10.5759 5.79445 1.91861 -2.10956 -11.6412 +634 1 6.75321 15.7504 6.59889 15.4627 0.902891 -8.22878 +635 2 7.26857 15.9454 7.3825 -2.17992 1.48032 8.28293 +636 2 7.22097 16.2558 5.90647 -13.1985 0.138133 2.05084 +637 1 6.44152 13.0383 5.65846 10.3967 8.14078 0.466175 +638 2 6.75357 13.9433 5.8413 -7.70657 -8.59676 1.70002 +639 2 6.06189 12.7174 6.48437 -0.213232 -3.44089 0.434225 +640 1 16.7867 12.5398 9.78373 -0.895423 12.3409 14.8939 +641 2 16.908 11.9251 9.05274 5.68732 0.178616 -8.50939 +642 2 17.2058 13.3939 9.58039 -4.06144 -12.2084 -5.14549 +643 1 6.11722 2.93773 2.78358 1.28645 13.216 -7.71479 +644 2 6.25944 3.86133 2.4934 3.99356 -9.45804 11.966 +645 2 5.80949 2.50246 1.9813 -4.27697 -8.38821 -0.209888 +646 1 10.8697 3.19981 3.26527 3.50346 -2.80617 2.55973 +647 2 10.3917 4.00785 3.47818 -6.11785 -2.03152 -1.59068 +648 2 10.4869 2.83625 2.45753 -2.48553 0.910808 2.03729 +ITEM: TIMESTEP +50 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.80494 6.94654 17.8995 24.4982 -1.06408 -3.00226 +2 2 7.9626 7.14317 18.2754 -25.5132 0.779993 7.28642 +3 2 8.754 6.09075 17.4755 -3.81212 -4.80634 -6.17786 +4 1 18.7076 8.28828 6.77862 -17.6183 19.7289 -45.7057 +5 2 0.378325 8.05756 5.8509 -9.14495 4.02657 32.4311 +6 2 0.533056 7.77742 7.41073 20.0311 -22.8668 16.2585 +7 1 8.47587 18.7144 6.8555 -15.9357 -0.720841 9.56566 +8 2 9.33674 0.260611 6.50709 17.8925 2.772 -5.71063 +9 2 7.894 0.699709 6.41588 1.40147 0.745568 -0.352682 +10 1 6.55032 1.74908 11.6806 -30.6389 -0.0206495 8.42613 +11 2 5.72229 2.20254 12.0188 30.9536 -14.8428 -8.23206 +12 2 6.26581 0.83583 11.4478 2.55871 18.5754 3.76962 +13 1 7.01034 5.66598 2.40366 42.8029 -38.9731 -13.6875 +14 2 6.35895 6.02285 2.96016 -30.9745 25.4116 27.1882 +15 2 6.9342 6.07183 1.55014 -9.7244 15.1829 -13.9093 +16 1 16.2046 10.2277 16.1038 24.2393 -12.7483 3.49627 +17 2 17.1446 10.5017 16.2161 -25.4373 -4.23616 -6.12234 +18 2 15.647 10.9645 16.3441 -0.0961828 13.5193 2.91036 +19 1 10.6483 14.9468 2.32679 16.6528 15.7411 4.7381 +20 2 10.6274 14.3584 3.09768 -0.623134 4.2367 -1.18236 +21 2 11.2712 15.6715 2.59359 -14.1521 -13.9994 -5.33424 +22 1 17.1661 8.23718 10.6306 -11.2967 1.73071 14.301 +23 2 16.7507 8.8212 11.3018 1.93853 -3.53361 -12.158 +24 2 17.9019 8.73965 10.2686 8.0864 2.26419 -0.719652 +25 1 14.7146 15.8737 16.457 -21.3602 13.4439 -13.9077 +26 2 13.7676 16.1527 16.3582 25.6738 -5.80999 2.03747 +27 2 14.7447 15.4629 17.3289 2.78446 -2.53877 0.107495 +28 1 12.1127 13.3961 0.516068 7.29043 -9.0569 -3.36162 +29 2 11.9491 13.4845 18.198 -4.88029 1.64951 11.237 +30 2 11.4672 13.8878 1.04861 1.29785 5.2885 -8.15688 +31 1 9.32313 5.46813 3.97213 7.80738 6.41636 -30.8752 +32 2 8.77956 5.22076 4.69796 -14.0602 -7.63701 27.6376 +33 2 8.66617 5.58024 3.26537 2.47672 -2.22308 0.129141 +34 1 1.75935 4.12111 11.6197 18.1342 -37.205 15.7411 +35 2 1.54791 5.00495 11.8916 -2.97584 25.4072 4.68628 +36 2 2.32145 3.72177 12.3424 -17.0092 10.631 -21.3466 +37 1 2.03979 6.80407 8.28533 9.98525 11.4794 16.6393 +38 2 2.53906 7.28349 8.98677 -9.97253 -7.08615 -13.1486 +39 2 1.84044 5.93856 8.67612 2.99865 2.8006 -7.53122 +40 1 5.41368 4.4431 7.98609 2.04847 -7.17668 -5.4397 +41 2 5.52021 3.53426 7.6768 1.69988 -8.04832 10.7211 +42 2 4.8597 4.83563 7.32005 -13.574 8.98698 -13.1921 +43 1 3.28639 2.94557 17.481 18.7711 -22.2673 -22.0629 +44 2 3.9564 3.24513 16.8336 -6.74837 -1.29983 9.82734 +45 2 3.01936 3.73284 17.9334 -14.3576 17.7403 14.3716 +46 1 7.43065 5.38409 6.1108 -4.02947 -12.3157 -7.88053 +47 2 8.04294 5.88377 6.62432 18.8075 23.5792 8.00277 +48 2 6.91671 4.96856 6.79731 -10.3369 -11.1081 4.55684 +49 1 9.79016 6.98523 11.9902 -10.4204 5.88316 -11.2143 +50 2 10.3735 6.44493 11.4296 -8.50476 3.87141 4.17676 +51 2 9.02941 7.28204 11.4255 18.3189 -8.29917 9.01359 +52 1 14.0741 3.64931 8.08693 10.5401 -0.215179 40.0548 +53 2 14.0167 4.44403 7.56769 -3.75439 10.9765 -10.3635 +54 2 14.3054 3.9684 9.00291 -5.13065 -9.75311 -28.2231 +55 1 4.53282 17.2396 3.96388 -3.36194 -12.9595 16.5635 +56 2 5.47422 17.3897 3.95236 14.0752 8.1678 -3.62607 +57 2 4.10275 17.6636 3.22639 -0.935466 5.38311 -16.6052 +58 1 16.4462 16.5922 10.2581 -38.5234 -1.88036 17.4962 +59 2 15.5721 16.6729 10.7424 33.2408 0.640367 -11.4138 +60 2 16.1948 16.0519 9.4989 1.36351 -0.703045 -4.07641 +61 1 1.99534 4.82647 0.326236 -5.72725 6.00108 -15.6714 +62 2 2.53752 5.17962 1.03714 5.87953 4.50688 4.90779 +63 2 1.76739 5.60304 -0.220726 -2.02535 -4.08014 4.56707 +64 1 11.5531 13.2812 16.3325 -4.55485 8.80091 5.86354 +65 2 11.0534 12.4701 16.4457 -6.69668 -7.45166 4.31247 +66 2 12.0841 13.1031 15.5561 8.82157 3.01133 -6.78989 +67 1 10.1577 11.0139 16.8858 -24.3839 23.6532 0.592397 +68 2 10.5791 10.1721 16.8528 10.3809 -28.4273 -2.47871 +69 2 9.20446 10.8554 16.7431 9.15295 -0.788439 1.53623 +70 1 11.769 17.4436 13.4724 -4.31264 31.1905 -3.85112 +71 2 12.3451 17.016 12.8258 4.51875 -1.42135 -0.782751 +72 2 11.9049 18.418 13.331 2.02313 -21.8103 4.25856 +73 1 6.43699 9.33747 12.2016 -14.3685 16.3251 29.571 +74 2 6.95929 8.94901 11.512 13.8657 -1.33735 -10.2504 +75 2 6.99936 9.91985 12.7612 -5.52999 -10.4188 -15.163 +76 1 16.2506 12.8362 2.68463 10.4823 17.07 -2.68352 +77 2 17.0784 13.3466 2.55935 -9.20242 -14.0812 1.4249 +78 2 15.565 13.5285 2.65461 0.126865 -8.38924 5.57615 +79 1 0.688432 12.6159 5.91845 40.3739 4.73102 13.6953 +80 2 0.965548 12.5027 5.00914 1.60296 -4.44104 -10.7732 +81 2 18.4099 12.7183 5.90627 -44.0147 0.977299 -7.7541 +82 1 5.23962 16.4285 18.4285 2.37714 -1.84876 8.0205 +83 2 5.78786 15.7427 18.0572 3.65919 -12.8888 -12.968 +84 2 5.57695 16.4825 0.678793 -3.22986 7.92557 6.36641 +85 1 0.598604 7.70507 4.14138 -20.7786 -13.2635 7.16681 +86 2 18.6305 8.09263 3.50172 -0.345103 1.12768 -4.13337 +87 2 1.46117 7.8354 3.77399 24.2365 9.84596 -7.22116 +88 1 3.12664 8.94501 6.49467 58.7355 2.96877 -21.5552 +89 2 3.79065 8.46432 7.02112 -12.6266 6.35685 -1.15291 +90 2 2.29097 8.86083 6.88074 -41.9399 -6.12221 23.1652 +91 1 7.26988 10.3368 16.2836 11.5372 -0.463039 -18.2668 +92 2 6.61986 10.5879 15.6307 -2.48374 3.02842 -3.04887 +93 2 6.78814 10.3049 17.1036 -3.00573 -3.18181 16.2709 +94 1 11.123 0.978368 5.0094 -10.4546 8.12706 3.20432 +95 2 11.0717 1.86722 4.62246 7.34447 -2.45893 1.30193 +96 2 10.765 0.419141 4.31729 -2.84542 -7.68945 -6.73121 +97 1 4.36745 2.7997 13.2283 -2.96005 27.1446 -27.16 +98 2 4.67681 3.13482 14.0684 -0.492375 -1.19152 9.60175 +99 2 4.17697 1.87548 13.305 -2.22526 -24.419 13.8486 +100 1 8.37947 10.1962 1.80259 -4.93469 16.4683 -10.3397 +101 2 8.22749 10.8872 2.46356 1.16914 -1.49574 -1.6966 +102 2 8.71062 9.47199 2.30942 8.47484 -21.3721 12.0127 +103 1 10.3811 1.71408 15.5377 20.686 0.359172 -10.6925 +104 2 11.354 1.66546 15.4316 -15.8773 -5.06945 10.6173 +105 2 10.0964 2.02238 14.6685 -5.35844 0.742925 -2.36882 +106 1 2.68357 12.8347 7.81396 4.59418 8.51704 7.17464 +107 2 3.18489 13.5948 7.4697 -3.72618 -6.19027 -0.541735 +108 2 1.90686 12.7457 7.24856 2.42229 -2.05385 -5.50174 +109 1 3.74169 11.6981 5.12659 20.4064 16.2552 5.07347 +110 2 3.6031 10.8525 5.51837 -2.34348 -17.0347 14.1119 +111 2 3.05756 11.7956 4.48632 -17.1397 4.43934 -14.0111 +112 1 6.78306 14.4202 16.945 8.30127 18.455 -2.7408 +113 2 7.70256 14.7228 17.0235 -7.00262 -4.27134 -0.857039 +114 2 6.4289 14.8468 16.1479 2.30915 -9.19793 -2.69046 +115 1 14.2185 14.5268 3.31588 -23.2154 9.18115 10.9982 +116 2 13.6682 15.2954 3.06852 12.5657 -5.26706 1.63848 +117 2 13.7604 14.1667 4.10581 9.83524 -2.33371 -14.8176 +118 1 8.44676 18.1227 16.0393 7.73472 16.3177 -1.68025 +119 2 9.01165 17.3799 16.1525 3.2644 -34.6246 10.2309 +120 2 9.11477 0.14931 15.8801 -4.9724 20.6673 -2.43491 +121 1 4.70679 1.64341 4.91058 -17.3364 -32.3489 41.2122 +122 2 3.86106 2.04855 5.10849 -6.14561 5.35271 -2.51022 +123 2 5.03045 2.1011 4.1778 23.045 28.1017 -39.82 +124 1 14.9769 12.6712 16.4491 28.5182 -25.5733 -37.1858 +125 2 14.5585 13.1664 17.1249 -24.0861 16.0366 17.7329 +126 2 14.4092 12.4828 15.6576 3.30334 14.0855 25.2157 +127 1 15.7195 18.4537 16.8862 -41.4911 -4.79998 -47.5194 +128 2 16.474 18.4695 17.416 41.6971 -5.3201 37.0536 +129 2 15.5173 17.5216 16.6763 -0.165283 4.31671 10.9236 +130 1 1.26675 1.20722 16.5821 1.91531 -3.73727 -7.96899 +131 2 2.06576 1.68562 16.7995 9.77153 8.32265 -0.296149 +132 2 0.695796 1.45596 17.2985 -12.9769 2.74169 12.7471 +133 1 18.1595 4.46894 15.9392 -8.68238 9.49864 15.6389 +134 2 18.21 4.01948 15.1094 2.12602 -9.4702 -15.5502 +135 2 0.321646 4.30297 16.4236 6.52219 -0.344151 0.382064 +136 1 12.2433 16.9631 16.1365 30.1535 25.9085 -42.0202 +137 2 11.4764 16.7912 16.6244 -43.4812 -17.6238 21.6018 +138 2 11.9609 17.1491 15.2014 5.35486 -10.4534 20.1012 +139 1 16.0404 2.55502 18.1172 12.6912 -10.4842 9.42679 +140 2 15.6589 3.39683 18.3503 -6.59057 14.1496 4.33812 +141 2 15.9441 2.46009 17.1755 -7.16214 2.08136 -15.1428 +142 1 6.70635 13.8458 10.192 -16.5385 -19.5662 -16.6234 +143 2 6.46743 13.4829 11.0519 3.62966 4.37567 6.36784 +144 2 6.41781 13.1513 9.56037 11.5929 10.5707 5.5488 +145 1 10.1419 18.3987 2.73425 -19.4638 -25.4286 12.0097 +146 2 10.2073 0.494584 2.15475 6.00155 18.7458 -18.7245 +147 2 9.2799 18.0069 2.48337 13.6051 6.39322 6.25061 +148 1 3.04438 17.7185 6.11283 5.61436 7.93422 -10.0091 +149 2 2.18521 17.5434 5.71014 -2.22655 1.93918 -4.29169 +150 2 3.60431 18.0006 5.35738 -6.06642 -9.44159 14.8188 +151 1 12.59 16.8727 7.99688 3.41749 0.26688 0.968442 +152 2 11.9163 16.1959 7.96054 -9.29683 -10.0995 -8.1817 +153 2 12.3648 17.371 8.78825 5.01363 9.11979 0.25951 +154 1 14.8925 15.2941 8.21002 11.8118 0.190541 -21.4145 +155 2 14.0466 15.7377 8.15471 -7.99071 7.70949 7.81769 +156 2 15.2804 15.4945 7.32486 -0.0803457 -7.85257 22.8773 +157 1 17.7158 18.2428 0.330134 42.1686 22.2301 9.80157 +158 2 18.5718 17.7519 0.320787 -20.6577 0.0591745 -9.59458 +159 2 18.0296 0.514827 0.540707 -19.3386 -19.3229 -5.27308 +160 1 0.848087 10.4587 1.36302 27.1846 51.9138 -28.6855 +161 2 0.125428 9.973 1.66463 -44.0007 -34.6793 17.9508 +162 2 0.450253 11.2027 0.827225 17.544 -22.8417 14.6566 +163 1 1.73752 12.2317 3.35921 -10.6222 -3.23772 -40.3174 +164 2 1.50468 11.5771 2.65039 3.80547 3.73659 24.0112 +165 2 1.78112 13.0447 2.82871 4.93945 -0.670418 11.0651 +166 1 0.61763 17.2312 4.89977 -31.3278 9.09129 49.7394 +167 2 18.753 18.067 4.93438 12.2337 -8.61092 -13.4292 +168 2 0.309388 16.8063 5.75223 19.8395 0.744545 -34.548 +169 1 1.12081 0.925337 9.40389 -12.5044 -10.6635 0.652446 +170 2 1.34187 0.581545 10.2981 -6.32089 4.74016 -12.6461 +171 2 0.253358 0.524348 9.17819 18.5788 9.22491 5.8567 +172 1 16.7331 2.36195 13.2995 -4.07693 -18.6231 24.2357 +173 2 16.9587 2.56306 12.4093 5.05193 8.99127 -27.3142 +174 2 16.5121 1.41005 13.3069 2.86591 9.33714 2.00751 +175 1 2.6752 15.8404 12.084 -17.9655 13.8891 -13.7444 +176 2 3.1007 15.4046 12.7977 10.8605 -10.5552 20.9848 +177 2 3.18035 15.6022 11.2985 0.61387 1.79975 -2.62876 +178 1 16.4324 15.6688 6.07894 -11.0906 -29.1832 8.11987 +179 2 17.3135 15.6699 6.4691 2.82688 3.86386 -3.5648 +180 2 16.3493 16.3586 5.42897 4.86465 16.2346 -9.8305 +181 1 5.78229 5.11191 11.8099 -13.8406 10.2937 3.29755 +182 2 5.26053 5.84491 12.2174 12.8802 -11.8636 -2.84442 +183 2 5.17337 4.36282 11.7377 2.58239 3.92087 3.15374 +184 1 15.1463 4.86734 0.794152 0.864651 12.4924 -33.9562 +185 2 14.9842 4.50309 1.65022 -3.17819 -5.74322 26.2661 +186 2 14.3662 5.39647 0.571272 5.91156 -4.56503 2.45287 +187 1 16.3343 16.3902 2.05204 -8.53913 3.9795 31.3204 +188 2 16.0972 16.7844 2.93864 3.99019 -13.2916 -26.145 +189 2 16.6713 17.1379 1.5654 4.18336 9.27065 -12.2854 +190 1 0.251768 4.84384 3.8243 -5.07672 -49.1083 -0.618349 +191 2 0.303365 5.75864 3.98841 7.12191 44.1717 7.46524 +192 2 0.849427 4.39339 4.43966 -1.76195 8.48948 -7.42491 +193 1 2.97026 15.0637 15.1648 0.961584 14.1925 -19.6325 +194 2 2.86359 14.8338 16.0871 -5.01806 -10.0022 10.5852 +195 2 2.57214 15.9549 15.1104 2.70735 -9.48442 0.706884 +196 1 1.14871 14.6442 9.53518 -42.8529 -19.211 3.24989 +197 2 2.06628 14.849 9.52706 28.3433 -3.949 4.37311 +198 2 1.01023 13.7361 9.90627 12.772 19.4662 -8.86837 +199 1 13.5229 16.5669 11.532 20.3549 -23.4698 16.7524 +200 2 13.3606 17.2446 10.8944 -12.6142 15.9017 -14.8664 +201 2 13.2357 15.729 11.1267 -5.06335 10.0173 1.96475 +202 1 4.64907 1.44855 0.782556 14.1843 16.2277 -15.4645 +203 2 4.13811 2.00007 0.175187 -1.198 1.13782 0.731863 +204 2 4.05002 0.760268 1.05534 -6.36237 -9.04178 10.9284 +205 1 1.45269 18.5669 11.8512 9.08594 -18.5638 20.5671 +206 2 1.3209 0.513151 12.6112 1.192 -1.45307 -0.682323 +207 2 1.82538 17.7349 12.2384 -6.22294 17.2853 -13.4176 +208 1 11.5083 10.14 3.99231 -12.3356 -6.67004 24.2683 +209 2 11.3008 10.4626 3.12291 -1.30093 6.41155 -12.7666 +210 2 12.4624 10.1697 4.04844 12.7044 -2.53047 3.95194 +211 1 8.22637 12.1595 3.70182 22.1984 -6.43536 -24.1249 +212 2 9.06359 12.543 3.994 2.39995 3.52197 1.898 +213 2 7.64229 12.2644 4.4292 -22.7553 4.87752 31.4773 +214 1 14.5041 4.04055 3.28708 -18.3332 1.47774 -0.327682 +215 2 14.9873 3.94029 4.11097 10.9182 2.80533 4.02706 +216 2 13.7169 4.55783 3.53097 2.05743 -3.46177 -0.871318 +217 1 5.62743 1.64825 7.52429 33.006 28.3977 -54.9531 +218 2 5.01294 1.12929 7.98513 -35.2623 -28.0367 23.7041 +219 2 5.43705 1.49837 6.5464 4.70081 6.15592 32.4881 +220 1 17.8649 1.10253 4.84999 -3.85271 -3.04411 9.89583 +221 2 18.5316 1.48406 4.28754 10.0589 0.579138 -13.4652 +222 2 17.9089 1.63153 5.65146 -2.44801 0.268727 5.2117 +223 1 6.82865 9.41118 4.50161 13.9732 -1.80028 18.7676 +224 2 6.94383 9.68391 5.43824 -8.65407 -5.40133 -16.2957 +225 2 7.70845 9.07477 4.25578 -5.27921 1.965 -0.840285 +226 1 2.66065 14.8943 1.98186 -2.57221 -9.24308 25.7982 +227 2 3.31586 14.7955 2.69868 -8.68087 -2.61777 -7.29774 +228 2 3.12007 15.367 1.30687 7.03004 7.53846 -18.6884 +229 1 17.3318 12.9277 13.2024 14.566 -8.41998 -6.98679 +230 2 16.4646 13.2932 13.3909 -3.11164 10.4066 0.365823 +231 2 17.9245 13.6681 12.9725 -15.6789 -3.68206 1.74475 +232 1 14.9332 10.5631 1.42248 26.9386 23.5346 15.1493 +233 2 15.5074 11.3103 1.7869 -22.4798 -24.8917 -12.2482 +234 2 14.0193 10.8096 1.5708 -2.19259 1.9486 -0.294463 +235 1 5.71089 6.73608 4.5629 -4.22281 28.118 -3.03355 +236 2 5.94827 7.69445 4.64343 -4.82413 -18.183 -7.3163 +237 2 6.31292 6.28304 5.16113 4.14578 -2.25186 0.1588 +238 1 7.97883 8.3192 10.3001 7.8407 -5.86676 -34.7961 +239 2 8.53275 9.01778 9.91692 4.61581 1.53144 9.76809 +240 2 7.67805 7.86001 9.48783 -4.88471 -0.599295 18.8237 +241 1 13.4226 18.4487 5.72909 4.08913 1.21656 -6.98532 +242 2 12.585 0.250804 5.52036 7.76092 4.80861 -0.84516 +243 2 13.2097 17.9386 6.50687 -2.642 -10.6174 11.5339 +244 1 0.0869602 2.62265 0.223952 -9.8031 -15.3274 -6.51765 +245 2 17.9117 2.88521 18.4333 -9.97249 -6.92357 5.22107 +246 2 0.604672 3.41479 0.198655 20.2406 16.0872 6.75582 +247 1 12.7806 11.0275 9.75202 47.836 -29.2198 23.6504 +248 2 11.892 10.9606 9.4924 -44.5823 -3.62186 -10.7645 +249 2 12.9839 10.1194 10.1272 -4.83434 23.2951 -13.1663 +250 1 0.705171 12.1501 11.0469 -11.5221 2.5881 -10.739 +251 2 18.3743 12.1368 11.1638 13.8029 4.27958 5.25964 +252 2 1.13401 12.4861 11.8379 -3.00537 2.27024 12.2218 +253 1 5.1174 7.31342 13.4172 11.1181 3.69095 0.765545 +254 2 5.61979 7.99643 12.9358 -2.94992 -2.73128 4.30069 +255 2 5.6521 7.15272 14.218 -5.77355 -1.15348 -7.33249 +256 1 1.197 6.86571 11.8595 38.3077 26.916 14.5555 +257 2 0.451078 7.27927 11.4324 -8.7071 4.85333 -5.01967 +258 2 1.83731 7.62187 12.0983 -31.0022 -32.2106 -6.42275 +259 1 15.4885 9.63727 12.3206 16.478 -29.8614 -10.1392 +260 2 15.1661 10.5006 12.1398 -12.0715 29.4427 -0.903292 +261 2 15.2587 9.41843 13.2151 -2.74274 1.51694 14.7591 +262 1 16.5678 12.6919 5.49509 2.68502 5.28083 21.2685 +263 2 16.324 13.6184 5.59953 -0.326156 6.48336 2.9395 +264 2 16.4016 12.5196 4.57887 -2.84479 -5.20052 -25.0662 +265 1 6.28213 9.87258 0.0490999 16.8985 1.83912 15.6964 +266 2 5.56262 10.3905 0.421328 -3.89363 2.12479 6.12138 +267 2 7.01982 9.90555 0.722608 -19.7924 2.8001 -17.1777 +268 1 12.2865 6.1036 4.06304 19.2748 24.5544 -29.5048 +269 2 12.3306 6.8161 3.36437 1.4085 -17.3408 22.8012 +270 2 11.3814 5.83426 4.0192 -21.2841 -11.2083 4.33393 +271 1 0.298047 12.7955 0.166375 -3.43648 3.64279 0.0778505 +272 2 -0.0290314 13.4316 0.817326 3.1389 2.62115 2.93426 +273 2 18.4391 12.9788 18.0124 -4.25126 3.67416 -7.60949 +274 1 3.647 18.6117 8.59889 -15.5834 11.8668 6.1299 +275 2 3.50703 18.267 7.70639 0.18727 -3.89186 2.0216 +276 2 2.76186 0.338497 8.83167 17.7751 -6.65964 -2.12733 +277 1 7.50606 17.376 4.49824 -10.0508 -46.4512 11.7168 +278 2 7.49016 18.3059 4.51667 7.03352 43.591 -0.815572 +279 2 7.72157 17.1186 3.60818 -1.05523 3.68228 -12.2984 +280 1 9.25162 17.1195 12.2401 -20.7119 -1.17481 -13.1138 +281 2 9.34873 16.3083 11.723 0.965197 -1.09758 -0.258815 +282 2 10.0653 17.2534 12.7074 19.1017 -2.42392 11.5163 +283 1 13.35 12.9891 7.98546 26.3101 20.7404 -8.62941 +284 2 13.4089 12.1901 8.49273 -4.66259 -15.0904 10.7497 +285 2 14.2093 13.4501 8.17144 -24.2961 -0.252284 -5.87391 +286 1 14.9018 2.99422 15.3537 -18.6075 -8.06583 14.6174 +287 2 14.2375 2.30647 15.2045 2.81445 1.4476 3.5012 +288 2 15.4631 2.94521 14.5905 14.0528 3.89371 -13.7736 +289 1 9.86333 15.5824 16.9775 -1.70109 -0.0675876 9.27141 +290 2 10.3396 14.7637 16.7526 0.856458 3.65656 -1.57854 +291 2 9.55317 15.4797 17.8978 1.12056 -0.962034 -11.839 +292 1 11.2957 8.40029 16.577 -16.0633 -20.1101 7.86553 +293 2 10.6817 7.8482 16.0424 7.68237 12.4971 4.88138 +294 2 11.3251 7.92133 17.4322 4.78934 8.39937 -13.6138 +295 1 3.89281 18.1695 16.7848 -3.14598 -18.8551 -14.8366 +296 2 4.41813 17.5168 17.2844 -2.97968 13.5676 2.86087 +297 2 3.87713 0.360621 17.2331 6.32956 9.89438 13.0847 +298 1 2.18947 4.17934 8.91366 -18.0693 4.35017 -17.8699 +299 2 3.09766 4.08917 8.6846 23.1764 -2.78898 -7.58361 +300 2 2.16493 4.06394 9.84833 -5.05649 -4.17918 28.8808 +301 1 9.87375 10.372 9.69798 10.3489 -25.1121 17.1783 +302 2 9.47622 11.1704 9.40878 -10.9495 28.2307 -13.2887 +303 2 10.0218 10.4724 10.6474 2.61027 -3.39635 1.23761 +304 1 9.66501 0.904023 10.8717 -13.0386 -22.5074 -9.87351 +305 2 9.3051 0.0213231 11.0865 8.01248 8.88818 8.11202 +306 2 9.06191 1.19139 10.169 9.00305 9.82525 0.172013 +307 1 9.18563 15.0903 10.2115 17.1556 13.6164 1.72702 +308 2 8.73275 15.8289 9.78742 -0.477718 6.62954 -2.89772 +309 2 8.53792 14.3995 10.1946 -15.8858 -12.7719 2.13472 +310 1 0.946133 9.58267 10.2797 -17.999 7.07835 7.04569 +311 2 0.977457 10.4775 10.6382 -6.96742 -0.068666 -4.76802 +312 2 1.85682 9.38261 10.1843 21.4216 -13.3352 -8.00245 +313 1 16.9414 4.83421 8.13223 15.4014 12.0295 -27.8426 +314 2 16.4342 5.57084 8.44793 -11.0978 12.5109 2.31217 +315 2 16.8158 4.17203 8.77314 -2.49922 -25.6846 24.7871 +316 1 14.7535 14.7061 0.203986 15.073 4.98951 -2.11802 +317 2 15.1043 15.2916 0.890887 3.3452 -1.27018 2.88153 +318 2 13.9621 14.3164 0.552408 -18.4772 -7.94901 9.40987 +319 1 3.67958 11.0243 9.53991 2.98139 -0.929731 17.0732 +320 2 3.55398 11.294 10.4695 5.20942 3.18167 -4.3207 +321 2 3.23108 11.6955 9.00414 -3.72853 0.365488 -5.84942 +322 1 11.2021 10.759 1.44219 -17.3262 -13.0718 -7.65614 +323 2 11.58 11.5828 1.16251 10.55 19.7497 -9.01804 +324 2 10.309 10.7579 1.05212 6.07305 -2.69648 6.21388 +325 1 13.1662 7.17502 12.7531 25.9391 -3.29657 1.887 +326 2 14.1362 6.96154 12.7671 -19.0435 5.16748 0.470499 +327 2 12.7272 6.32599 12.8606 -4.03684 -6.30893 0.442018 +328 1 9.61497 1.86018 0.978015 -9.58691 9.0933 -29.7593 +329 2 8.82052 1.59363 0.443821 14.7013 3.9795 16.3864 +330 2 10.1598 2.41617 0.376969 -4.12787 -12.2318 8.97473 +331 1 10.6544 13.5231 4.58863 -13.6132 -6.73185 -2.44549 +332 2 11.4017 12.9559 4.77554 12.969 -5.04099 -4.5155 +333 2 10.624 14.0848 5.36102 -2.93668 8.13722 11.8558 +334 1 14.451 1.77042 10.9566 -5.06993 -21.3108 1.92478 +335 2 15.2282 1.34301 10.5576 -2.05514 6.77792 0.416034 +336 2 14.5487 2.7176 10.8324 3.84606 4.21375 0.609558 +337 1 14.5616 12.2019 11.6619 17.6804 1.81894 22.1071 +338 2 15.3038 12.427 11.1092 19.6924 5.46932 -2.69443 +339 2 13.8862 12.1117 11.0284 -35.3643 -9.54852 -21.0379 +340 1 8.20666 5.07147 9.84086 19.0973 -30.0877 -21.2342 +341 2 7.45963 5.1784 10.3955 -25.2729 10.7477 18.5337 +342 2 8.15765 4.10536 9.6198 7.47394 24.0469 -0.436218 +343 1 1.5637 16.9015 18.3956 -12.4387 -25.8837 12.5929 +344 2 2.10927 17.2609 17.7108 10.7809 10.3745 -20.1818 +345 2 1.47705 15.9462 18.1578 7.28008 19.3441 8.23831 +346 1 1.51254 17.2865 15.33 -55.1424 19.1245 13.5119 +347 2 1.44158 18.2256 15.6397 11.4216 -23.3977 -5.64032 +348 2 0.55797 16.9673 15.4072 37.0312 4.44622 -8.61518 +349 1 3.63692 5.75726 6.07961 7.7365 -18.3794 -8.43759 +350 2 3.1745 6.31944 6.69962 -9.61621 11.1355 4.40451 +351 2 4.08899 6.28836 5.40075 -0.121738 1.87808 9.22135 +352 1 12.4625 9.47055 14.2033 -9.88788 31.7301 7.89028 +353 2 12.9131 8.72585 13.8435 10.9703 -26.4307 -11.7769 +354 2 12.2412 9.2145 15.1039 -0.841012 -4.82452 5.58465 +355 1 4.05279 15.2823 6.91192 -35.0907 -10.5097 14.3913 +356 2 3.49702 16.0377 6.67476 5.8423 0.670453 -1.17602 +357 2 4.92638 15.5321 6.67665 32.7349 8.37925 -5.72993 +358 1 0.666426 8.62945 15.01 -4.81633 6.31993 2.8284 +359 2 0.390025 9.55783 15.0778 2.6081 -0.187855 1.05312 +360 2 1.36445 8.64555 14.3512 6.1817 -1.74341 -6.99991 +361 1 12.9834 8.27358 10.2916 -19.5051 6.59204 10.6567 +362 2 13.6375 7.73399 9.85191 12.7638 -5.94229 -3.5145 +363 2 12.8815 7.86968 11.1799 4.96282 8.38227 -11.7258 +364 1 15.3269 7.75333 3.56288 29.5219 38.2257 -22.8776 +365 2 14.5855 7.35684 3.13467 -21.9298 -17.371 4.59449 +366 2 15.5403 7.50003 4.45743 -10.8574 -16.6026 13.017 +367 1 17.2887 6.69393 0.021468 15.5778 -19.6292 8.74644 +368 2 16.7574 5.92192 0.248673 1.14134 -1.83764 1.32773 +369 2 16.6558 7.32534 18.3698 -22.9594 20.3863 -6.57681 +370 1 8.86981 6.94597 7.81474 24.2415 27.8548 -9.55577 +371 2 9.77577 7.36617 7.90295 -24.2622 -15.8521 -2.69303 +372 2 8.7837 6.29392 8.50186 -0.35036 -13.7271 19.3897 +373 1 12.3819 0.576227 1.23609 4.50683 -3.19553 -2.96149 +374 2 13.3476 0.534404 1.26268 -2.04299 5.45052 6.49319 +375 2 12.129 0.50298 0.316799 -1.00379 -2.5807 -2.54403 +376 1 5.62478 15.1294 14.5559 -8.95515 -20.8805 6.21096 +377 2 4.66749 15.251 14.733 11.0075 0.339747 -2.61971 +378 2 5.99586 15.9305 14.1948 2.79164 18.0184 -3.26028 +379 1 3.86891 6.41255 1.75203 -0.0773217 -5.81596 13.5476 +380 2 3.55695 7.28194 1.50076 -6.60469 12.2107 -8.14743 +381 2 4.09127 6.52195 2.68979 -0.816275 -1.80663 -6.76426 +382 1 3.9342 11.5843 12.3776 -18.6931 -4.72392 -0.912594 +383 2 4.79227 12.0122 12.4616 2.30575 0.246561 2.78418 +384 2 3.29871 12.1178 12.8946 9.72132 -5.51488 -9.32366 +385 1 5.32882 3.8676 15.8786 0.594801 -80.2026 -15.123 +386 2 6.00417 3.18473 15.5574 -21.0433 25.388 14.8589 +387 2 5.72544 4.69544 15.8213 26.1638 51.9163 -2.72297 +388 1 14.3304 10.2034 4.48175 -27.4096 24.8129 53.7077 +389 2 14.5884 9.79586 5.33863 -8.33179 4.59428 -12.4543 +390 2 14.8538 9.80174 3.84099 29.6706 -27.6476 -38.9945 +391 1 7.77951 17.4021 9.16969 8.83259 -7.31352 -4.45478 +392 2 6.90706 17.6601 9.4324 -15.0276 -0.0996042 12.8709 +393 2 7.95009 17.9588 8.40488 9.49987 1.3194 -6.72214 +394 1 4.51552 14.5162 3.99356 4.98181 -4.90212 -22.3913 +395 2 4.52626 15.4247 4.27156 -0.518589 17.7617 2.00307 +396 2 4.31207 14.0204 4.77138 -3.57212 -17.3619 18.7252 +397 1 14.1875 7.4375 15.7998 -22.901 -10.8896 -16.0938 +398 2 15.1146 7.35808 15.6286 24.9688 -1.25651 -4.60954 +399 2 14.1131 7.89225 16.6248 1.32628 8.65776 19.0596 +400 1 2.98527 18.3068 1.9119 -4.72699 -30.9822 -37.1172 +401 2 2.49826 17.7826 1.20191 12.7581 13.6458 27.4428 +402 2 2.34371 0.225349 2.32895 -15.9948 14.8465 9.72817 +403 1 8.01181 1.59883 4.56348 -29.7821 5.07108 -10.5683 +404 2 7.46781 2.03632 3.88017 -2.37558 -3.45248 10.775 +405 2 8.87859 1.65459 4.20584 24.9106 -1.40589 -4.13938 +406 1 2.43696 14.1424 17.6778 32.6678 8.55365 0.150748 +407 2 1.74447 13.6484 18.0869 -17.757 -15.5673 8.49591 +408 2 3.25626 13.7213 18.0204 -5.64692 6.54589 -2.94203 +409 1 0.856601 1.76819 13.8909 -34.0133 7.6587 12.0684 +410 2 0.79549 1.64555 14.8654 10.1884 -1.39389 -18.6264 +411 2 18.5699 1.97567 13.6249 24.5068 -3.80874 6.24474 +412 1 4.3972 0.0813689 13.9033 -13.8751 0.78744 16.7708 +413 2 5.2251 18.2898 13.7459 20.8939 -4.75733 -3.28132 +414 2 4.21678 18.5292 14.8441 -3.95615 2.50922 -10.6456 +415 1 7.163 0.723926 18.3524 28.8431 -20.8152 -22.3389 +416 2 7.29578 0.265373 17.4701 -6.89821 16.5948 25.8874 +417 2 6.28988 1.09447 18.4079 -18.4483 2.86302 0.00697782 +418 1 16.0461 18.4126 13.9592 23.9709 4.87143 24.0859 +419 2 15.127 18.3862 13.8391 -39.1169 -4.38354 -15.9017 +420 2 16.1011 18.5404 14.9193 8.5862 0.360016 -3.75437 +421 1 10.1416 4.5234 16.2814 33.6533 37.5162 -8.59515 +422 2 11.1148 4.69187 16.0483 -33.0569 -13.9639 15.4314 +423 2 9.96481 3.59397 16.253 2.9151 -23.0089 -4.34536 +424 1 15.9284 17.7644 4.42623 32.451 -11.9188 -9.4973 +425 2 16.5348 -0.134683 4.55752 -3.00893 1.73986 -2.0661 +426 2 15.0985 18.0471 4.75447 -36.3204 13.6328 11.8833 +427 1 7.01478 17.4412 13.8546 -37.2955 -8.85564 -21.6385 +428 2 7.52749 17.7553 14.5758 15.4879 9.12118 24.9138 +429 2 7.64547 17.2338 13.1683 11.7367 1.38126 -7.54157 +430 1 13.2517 6.48941 6.59541 21.6379 18.6409 -4.45059 +431 2 14.0732 7.02646 6.4901 -17.572 -15.5204 8.29538 +432 2 12.9904 6.33391 5.6816 -8.39128 -3.46546 0.217322 +433 1 7.82903 2.34082 9.30706 0.848413 1.46751 38.8479 +434 2 7.32489 2.17899 10.1397 9.78087 5.93227 -12.3925 +435 2 7.21411 2.12937 8.62642 -15.7826 -8.09866 -24.9258 +436 1 15.1931 14.7992 13.6996 5.60594 -14.9485 0.236255 +437 2 14.8724 15.0774 14.5533 -1.16755 2.2837 13.7936 +438 2 15.0044 15.5062 13.0994 -6.5851 10.7381 -11.5383 +439 1 9.39722 8.31385 3.80437 -4.07127 17.2834 -4.44624 +440 2 10.2713 8.68973 4.00761 -3.0526 -2.08627 -0.470344 +441 2 9.46128 7.36215 3.86627 5.27028 -8.92187 3.93672 +442 1 17.7859 13.5845 16.3834 -19.0466 -29.0207 18.2461 +443 2 16.8295 13.3731 16.3512 7.31415 3.8698 0.00611806 +444 2 17.8697 14.4051 15.917 1.12921 18.7325 -11.1152 +445 1 4.94376 10.5922 2.82245 -18.0715 22.8685 -14.9529 +446 2 5.66076 10.3167 3.37377 16.0421 -11.7082 13.1735 +447 2 4.72943 11.4907 3.12728 0.871258 -13.2337 -1.99455 +448 1 3.75648 8.36099 10.0882 -2.83158 17.8244 -9.78689 +449 2 3.88314 9.30809 9.8443 -3.15161 -16.2727 -0.870444 +450 2 3.74879 8.36585 11.0419 0.849549 -1.60464 13.0402 +451 1 15.9818 6.99244 6.07768 -13.3688 18.7296 1.03973 +452 2 16.7792 7.41732 6.38792 13.9106 3.61693 3.9934 +453 2 16.2026 6.08994 5.88298 6.53831 -20.9898 -2.75314 +454 1 15.1161 7.11481 9.04764 0.565665 -31.7989 38.5144 +455 2 15.8028 7.45918 9.62834 5.57768 4.61323 -0.34974 +456 2 15.1416 7.62578 8.27782 1.5606 28.4329 -39.6698 +457 1 6.26636 12.9592 12.746 15.2088 -10.2167 -2.30532 +458 2 7.09456 12.5046 12.9751 -5.12301 -5.10662 -0.512627 +459 2 6.13107 13.5604 13.4742 -6.25916 17.1748 9.55337 +460 1 12.1295 4.51914 13.098 -40.0586 -31.7334 -0.542355 +461 2 12.3128 4.55827 14.0372 7.66008 7.87672 6.17129 +462 2 11.3118 3.91999 13.0515 32.2373 26.2449 -7.62055 +463 1 11.3854 8.14886 7.92202 -18.4022 6.94815 -10.6415 +464 2 11.9487 7.53516 7.44565 12.5498 -6.92106 -4.31871 +465 2 11.7891 8.26504 8.77918 7.07043 -0.608458 13.7447 +466 1 17.1486 10.8722 7.52372 -29.3422 15.2924 19.4167 +467 2 17.741 10.1746 7.28593 21.144 -15.6164 -13.9006 +468 2 16.9754 11.4691 6.78151 4.60435 -5.53137 -7.06809 +469 1 5.26553 18.1239 10.9774 20.3802 -2.13667 -3.01104 +470 2 4.75345 17.8709 11.7323 -12.4512 -5.88679 12.7575 +471 2 4.64325 18.2391 10.2688 -13.5246 2.23536 -17.92 +472 1 7.60715 17.4884 1.7834 -2.49749 -8.82149 -34.1915 +473 2 7.92668 16.7242 1.2322 -11.5566 19.54 16.0619 +474 2 7.18999 18.106 1.13139 15.7932 -7.79309 14.6318 +475 1 1.92845 12.8983 13.5911 -4.1829 -6.61346 -8.43532 +476 2 1.49445 12.3761 14.2737 -4.42561 -3.96966 1.7572 +477 2 2.30088 13.6477 14.0465 3.83448 15.9215 12.3791 +478 1 9.57624 6.80131 14.8487 2.82943 -31.3701 -0.177857 +479 2 9.74438 5.86263 15.1368 -4.04832 25.5486 -0.431769 +480 2 9.80341 6.81631 13.907 0.113844 6.0265 -0.426062 +481 1 15.2789 4.31862 10.7553 12.937 12.8557 31.6205 +482 2 16.1415 3.96953 11.0436 -5.39931 0.983411 -21.2391 +483 2 15.1479 4.98349 11.4601 -8.5537 -3.88808 -14.9921 +484 1 11.2581 6.18474 0.159508 31.1076 25.8623 9.85053 +485 2 11.549 5.31982 18.5294 -8.46095 -20.0483 -6.31791 +486 2 10.3153 6.29854 0.132928 -17.8901 -6.88616 -7.00405 +487 1 -0.015613 11.3989 15.0155 5.52071 0.0143375 15.3818 +488 2 18.1286 11.6803 14.2478 -6.84029 3.18322 -8.47428 +489 2 -0.24984 12.0811 15.6717 7.42423 -4.02873 -7.86488 +490 1 7.04792 9.26093 7.28081 24.8295 12.5521 -3.74072 +491 2 6.59027 8.49663 7.6071 -13.7147 -18.0719 7.78469 +492 2 7.98742 9.01504 7.31689 -8.33941 1.9664 -1.88331 +493 1 18.3308 15.3469 12.3202 -6.03602 -2.26652 6.8961 +494 2 0.60478 15.4762 12.0772 12.6515 4.5696 -6.24084 +495 2 17.7927 15.7945 11.6538 0.941578 1.81095 -5.33876 +496 1 16.5149 4.38922 5.26132 -0.591505 19.7601 -54.4807 +497 2 16.8056 3.98806 6.0517 15.8153 -15.5532 32.6352 +498 2 17.2724 4.45951 4.61195 -16.46 -3.71476 24.2381 +499 1 17.705 3.15738 10.7395 -3.58994 -28.0349 -4.43916 +500 2 -0.0357658 3.31586 11.0143 13.799 7.93723 3.46651 +501 2 17.7252 2.25587 10.3433 -5.09014 14.337 3.42017 +502 1 12.282 -0.0102014 10.1171 1.80463 -26.6374 -6.99772 +503 2 11.3739 0.250254 10.2263 -16.4794 9.03176 6.86793 +504 2 12.791 0.759276 10.3145 17.2573 22.9944 3.87451 +505 1 10.3906 9.77529 12.4736 -11.6246 -18.6488 -11.2601 +506 2 11.1162 9.76462 13.0993 9.33947 3.77576 6.26492 +507 2 10.2448 8.81959 12.3007 0.540403 13.8663 1.27912 +508 1 0.620737 2.80838 7.04076 1.85552 -26.9198 -9.07562 +509 2 0.56001 3.58776 7.58035 -0.0658531 10.9425 14.6075 +510 2 1.10446 2.13014 7.5549 -9.15748 13.0523 1.42789 +511 1 0.330306 15.2957 6.90187 -7.34135 39.0889 57.248 +512 2 0.64916 14.9551 7.78023 -6.58887 6.78122 -17.5325 +513 2 0.549392 14.6745 6.26262 18.9985 -47.7984 -33.3782 +514 1 17.0475 6.9988 15.1595 3.61332 2.27156 3.35689 +515 2 17.7695 7.63103 15.0486 -1.58895 3.22527 -3.41358 +516 2 17.4554 6.32111 15.7084 -3.97121 -9.30147 -1.03946 +517 1 9.1229 12.4841 8.04245 42.4716 -17.0961 -6.2748 +518 2 9.3803 11.751 7.44403 8.89783 14.9312 6.88846 +519 2 8.20686 12.4452 7.97952 -55.5673 6.80073 1.54221 +520 1 1.25348 1.79037 2.92813 -6.45569 8.99744 5.64127 +521 2 0.618969 2.05555 2.26044 -0.811293 0.804254 -10.1384 +522 2 1.53437 2.62736 3.32834 8.32683 -8.65344 1.50874 +523 1 4.08283 15.132 9.84955 18.6585 -7.67887 -4.13383 +524 2 4.13303 15.3467 8.91064 -4.64689 1.73023 -5.13685 +525 2 4.95775 14.7288 10.0227 -10.2431 6.10486 1.39562 +526 1 7.30601 2.19422 14.6517 -6.95706 -8.0865 3.71032 +527 2 7.17746 1.61632 13.8834 -0.940722 6.01065 3.73041 +528 2 7.50104 3.06853 14.3169 9.18921 6.42869 -7.97623 +529 1 18.506 14.6308 2.17255 -30.1365 -0.614545 -1.61255 +530 2 0.727688 15.0378 2.26332 7.05 8.92743 1.17189 +531 2 17.7886 15.3173 2.20949 19.3309 -8.24877 -2.15246 +532 1 9.97566 2.72581 12.9114 -11.2099 12.673 12.9937 +533 2 9.86165 2.06107 12.2382 3.86591 -12.7401 -14.4562 +534 2 9.16654 3.26167 12.8314 9.11555 0.77907 4.27596 +535 1 2.93178 8.92582 13.081 1.70152 2.66119 1.53014 +536 2 3.14805 9.86555 12.9479 4.31652 -6.20308 -1.56758 +537 2 3.73073 8.51399 13.4597 -8.92719 0.122715 -5.32652 +538 1 3.2497 8.49808 3.73135 7.7637 26.6897 -66.399 +539 2 3.59457 9.35475 3.3251 -8.07179 -35.8245 7.88572 +540 2 3.32757 8.66083 4.63283 0.688531 4.50937 55.9505 +541 1 5.66796 7.21231 8.59238 -0.641232 -8.3741 -2.33168 +542 2 5.55885 6.25431 8.52804 10.6614 2.37054 -1.78385 +543 2 4.98671 7.4468 9.22816 0.961703 9.61661 1.51464 +544 1 14.8738 1.42122 1.93778 -12.939 -8.09002 14.9013 +545 2 14.5066 2.19936 2.41013 13.5309 -5.26917 -12.7438 +546 2 15.3961 1.64306 1.16722 2.80937 13.5796 -4.98575 +547 1 8.4154 15.1394 0.773463 -1.23857 3.93157 -9.75401 +548 2 9.15191 15.1483 1.39458 4.79594 -7.97678 6.77178 +549 2 7.72939 14.5584 1.13871 1.01453 -0.106788 3.48853 +550 1 15.5631 1.364 7.19799 20.5383 14.1474 18.9399 +551 2 14.9704 0.811359 6.72127 -20.082 -15.4085 -14.9718 +552 2 15.0111 2.04928 7.59859 -2.39038 6.78983 -5.63995 +553 1 5.04086 13.0229 18.4653 -16.526 -4.40388 -18.1368 +554 2 5.51186 13.0765 0.64315 8.46246 3.02378 17.117 +555 2 5.66208 13.3388 17.7987 -1.33855 -1.44241 4.73678 +556 1 15.3891 8.54048 18.1286 -6.10206 -9.0298 20.9903 +557 2 15.6702 9.06907 17.396 9.32842 15.5064 -17.6225 +558 2 15.3407 9.15597 0.239346 -3.25407 -2.5962 -5.00154 +559 1 12.0788 3.07289 18.3192 12.549 -10.6185 1.49283 +560 2 12.5729 2.60825 0.359083 -9.10594 9.02489 11.6275 +561 2 12.4194 2.60778 17.5512 -7.87867 2.96301 -9.52933 +562 1 13.1665 12.6793 5.14706 7.93439 -3.9476 12.1924 +563 2 13.7696 11.9755 4.86963 -4.91093 -2.83846 -5.3825 +564 2 13.2489 12.6724 6.11347 -1.2685 5.53825 -1.32442 +565 1 6.04116 7.20215 0.12064 7.04453 6.18255 -12.3628 +566 2 5.83851 8.12748 -0.154348 1.72696 -16.7644 14.2262 +567 2 5.20617 6.73813 0.252386 -0.898724 4.83199 2.26117 +568 1 17.6547 15.8889 14.9543 35.0528 -4.14946 21.8068 +569 2 16.7907 16.2722 15.0644 -14.9966 1.76464 -15.1201 +570 2 17.9353 15.7106 14.0428 -17.4402 7.26196 -6.43436 +571 1 13.1733 0.917277 16.6395 -12.3557 8.76343 2.76166 +572 2 14.0527 0.785776 16.9891 12.1183 -2.33791 -0.0845054 +573 2 12.8033 0.0287439 16.599 0.155899 -2.85039 -4.8341 +574 1 10.9713 14.5555 7.36537 -14.2255 -14.9035 9.86762 +575 2 10.1709 14.1495 7.79489 23.622 7.7433 -12.5051 +576 2 11.716 13.9517 7.54396 -5.74804 5.50666 -0.0050929 +577 1 17.5337 8.50243 2.08938 -5.40396 -31.7286 -5.54565 +578 2 16.6651 8.377 2.51924 11.1588 5.07358 -2.60802 +579 2 17.6234 7.66639 1.54889 -0.0314299 30.6214 9.39113 +580 1 12.3599 7.90174 1.98937 3.23567 -16.3128 -6.49447 +581 2 11.7961 8.65526 1.85661 -2.62113 17.411 2.96359 +582 2 12.056 7.28247 1.30894 3.22552 -0.339632 3.88847 +583 1 11.9987 14.6627 10.3756 12.942 21.9862 15.1728 +584 2 12.1481 13.8459 9.95801 9.02096 -31.6093 -18.7525 +585 2 11.0572 14.7574 10.3761 -24.4084 6.55121 -1.49817 +586 1 6.83545 6.97591 15.5496 -11.1581 -18.4558 -7.96595 +587 2 7.75433 6.91064 15.3306 20.697 -3.79434 -9.10488 +588 2 6.829 7.75126 16.0755 -7.29309 23.7102 19.2635 +589 1 8.01446 4.61093 13.3684 -42.1501 -10.3174 -21.1074 +590 2 7.18404 4.82769 12.8493 26.4504 -9.34552 12.0218 +591 2 8.34807 5.45326 13.6307 9.05324 16.4922 6.04122 +592 1 13.4266 12.1814 14.3212 -6.42777 -0.785601 -11.9683 +593 2 13.0158 11.3184 14.1828 2.17743 -6.12306 4.21948 +594 2 13.8675 12.3621 13.4761 -0.124998 4.48227 1.48561 +595 1 14.6825 9.43166 7.27492 9.85972 28.3832 27.9741 +596 2 15.5174 9.92891 7.46534 -14.0141 -13.1604 -8.13985 +597 2 14.0576 9.79435 7.94424 7.51867 -12.8522 -19.303 +598 1 12.7091 16.9592 3.18265 16.188 -54.3303 -7.24671 +599 2 12.7269 17.2341 4.07879 2.36138 14.6014 27.6129 +600 2 12.279 17.6213 2.6979 -21.2589 39.1636 -23.5451 +601 1 1.03636 7.13727 17.3765 4.75158 -4.20474 15.7377 +602 2 0.172257 7.41544 17.719 4.25282 -10.0113 -2.57097 +603 2 1.1139 7.5113 16.5007 -3.03142 8.85376 -8.54904 +604 1 12.882 5.00728 15.6915 -13.3168 2.35737 2.40623 +605 2 13.5933 4.38686 15.8029 14.6532 -13.0711 -0.480408 +606 2 13.3236 5.8608 15.7721 -0.35756 9.80313 -2.71263 +607 1 2.42233 3.36085 5.14652 -1.4819 -20.4954 -28.2661 +608 2 1.78479 3.2289 5.83557 -10.283 -5.3637 15.3955 +609 2 2.79623 4.21009 5.29825 15.429 26.5106 10.9541 +610 1 8.29403 11.1124 13.578 -10.7346 17.3121 -71.8204 +611 2 8.44225 10.8317 14.4188 2.94407 -17.9634 86.1576 +612 2 9.02074 10.6663 13.1421 6.44484 1.50589 -14.4967 +613 1 12.9406 1.47026 13.2897 0.354478 -37.8914 22.4103 +614 2 13.6523 1.40022 12.6671 11.2026 2.70228 -18.849 +615 2 12.6313 2.34545 13.2159 -11.96 35.388 -6.53093 +616 1 6.51021 13.5896 2.17003 14.8824 -7.80817 -21.2989 +617 2 5.87965 13.8406 2.83705 -10.6705 6.78718 16.3658 +618 2 7.14425 12.9838 2.58896 -6.69863 7.51381 1.45504 +619 1 15.9112 6.50963 12.6885 16.1371 8.47906 -9.98075 +620 2 16.4229 7.02402 12.0187 -10.4906 -13.771 14.0264 +621 2 16.4535 6.54884 13.5054 -11.4677 1.21509 -6.34034 +622 1 16.8027 0.705691 9.58115 1.1294 19.8318 -8.72086 +623 2 16.927 18.412 9.70296 -4.50862 -18.5326 4.35013 +624 2 16.4766 0.834017 8.66778 -1.09927 -3.21438 5.98018 +625 1 6.10776 11.6244 8.30817 -7.08025 31.3016 10.3571 +626 2 5.31117 11.3633 8.78813 -2.85933 -0.839224 -1.79107 +627 2 6.50869 10.8152 8.04097 10.2317 -24.1838 -9.43106 +628 1 2.82434 8.71866 0.367104 27.0695 8.27339 20.5452 +629 2 2.22535 8.20379 18.5266 -22.1964 -28.7808 -30.261 +630 2 2.24775 9.38106 0.731441 -2.19807 14.7641 10.188 +631 1 10.1092 10.4559 6.56308 -0.703462 -11.3062 5.02538 +632 2 10.4957 9.70218 7.03882 1.80116 3.11275 -0.176711 +633 2 10.5447 10.4553 5.70619 3.2422 0.610478 -8.25928 +634 1 6.77867 15.7679 6.62657 -1.68281 -11.8864 -9.65654 +635 2 7.19346 15.995 7.46341 4.74707 6.17504 0.549944 +636 2 7.26738 16.2069 5.90636 -4.84487 7.71134 8.89334 +637 1 6.4599 12.9833 5.69613 7.9309 12.6721 2.99822 +638 2 6.6611 13.9194 5.88765 -3.42976 -10.7335 1.27405 +639 2 6.10779 12.6203 6.51977 -0.735551 -2.83601 -1.42622 +640 1 16.7784 12.5316 9.7686 6.64513 16.9355 2.79564 +641 2 16.9553 11.9755 9.0112 -1.14761 -14.6768 -5.4217 +642 2 17.3143 13.3158 9.58219 -8.26404 -2.19889 6.01862 +643 1 6.14902 2.92407 2.76687 9.25618 8.55881 7.16487 +644 2 6.44579 3.84137 2.53376 -9.69316 -20.3131 -2.03165 +645 2 5.73381 2.47389 2.01355 1.00911 7.28801 -3.60537 +646 1 10.8507 3.14979 3.2526 -8.20022 -5.11042 -1.435 +647 2 10.2526 3.87795 3.44424 2.28516 4.24005 3.08111 +648 2 10.4324 2.67577 2.52169 3.50832 1.84172 1.62718 +ITEM: TIMESTEP +60 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.82699 6.8727 17.8888 7.11742 1.34647 0.262135 +2 2 7.99 7.13914 18.2565 -12.0864 4.19935 8.4109 +3 2 8.62901 6.07007 17.4227 -0.244169 -11.025 -10.1388 +4 1 18.7394 8.29949 6.7561 2.34576 -2.93089 -42.9257 +5 2 0.440553 7.9626 5.87052 -19.1153 18.5732 27.9896 +6 2 0.571955 7.78688 7.39134 9.59653 -12.4008 18.4821 +7 1 8.51178 18.783 6.87295 -6.05415 -5.58023 12.25 +8 2 9.39304 0.279078 6.53812 12.1519 1.3365 -4.9205 +9 2 7.9628 0.741428 6.37316 -1.87647 6.654 -3.74148 +10 1 6.53357 1.7197 11.6944 -32.7429 -8.61455 3.24653 +11 2 5.73579 2.18358 12.0739 27.4882 -10.0969 -10.5409 +12 2 6.18445 0.855878 11.3477 8.95005 26.2974 10.8481 +13 1 6.96535 5.62987 2.3961 35.6431 -32.0928 -15.0783 +14 2 6.38293 5.93218 3.05619 -24.6612 16.4463 30.6134 +15 2 6.84916 6.21974 1.66578 -5.97717 13.8881 -18.7681 +16 1 16.1974 10.2298 16.1222 0.837184 6.4903 1.28091 +17 2 17.0743 10.6189 16.0747 2.49014 -9.13099 -5.48379 +18 2 15.6463 11.0038 16.2733 -2.87215 -2.05097 1.79245 +19 1 10.6702 14.9469 2.31164 21.9083 12.0632 13.3283 +20 2 10.6818 14.2862 3.02723 -4.43621 6.7471 -1.73288 +21 2 11.263 15.6645 2.64965 -13.2726 -10.9824 -6.65814 +22 1 17.1701 8.22403 10.7142 -10.4028 1.03109 3.96163 +23 2 16.5672 8.79102 11.2349 7.05768 -1.94337 -2.70487 +24 2 17.9333 8.77716 10.499 4.44622 1.4788 -2.07857 +25 1 14.6797 15.9035 16.4693 -22.461 3.39408 -16.7947 +26 2 13.7484 16.2021 16.2951 24.3498 -9.2952 11.1 +27 2 14.6463 15.3225 17.2482 2.4047 10.3841 -3.14234 +28 1 12.1037 13.3669 0.54665 -3.27844 11.868 -6.89748 +29 2 11.8248 13.5865 18.2899 5.63772 -9.83511 -2.25753 +30 2 11.6388 14.0254 1.08354 0.310925 -7.08728 5.11983 +31 1 9.3344 5.48343 3.92748 33.8763 5.32583 -18.4372 +32 2 8.84687 5.22044 4.68611 -23.4915 -4.94858 24.7343 +33 2 8.7079 5.56619 3.20676 -14.265 -0.820383 -3.61874 +34 1 1.71101 4.06482 11.6122 14.6912 -29.1046 6.03323 +35 2 1.58258 4.96723 11.8918 -1.25551 20.6962 3.43651 +36 2 2.34968 3.65386 12.2459 -15.6865 7.58906 -11.285 +37 1 2.0576 6.82445 8.24528 12.7796 11.6573 13.2587 +38 2 2.61911 7.2356 8.94539 -14.081 -6.70064 -12.0447 +39 2 1.89349 5.9205 8.55263 1.83531 2.80349 -1.77694 +40 1 5.39864 4.45401 7.95786 1.68333 5.33174 7.59028 +41 2 5.55249 3.50745 7.87389 -3.64833 -7.88894 -5.24716 +42 2 4.83854 4.74959 7.2381 -8.525 -1.92619 -10.156 +43 1 3.30216 2.93412 17.4505 12.3495 -29.8256 -18.8762 +44 2 3.92727 3.3713 16.8479 -0.637689 -1.64749 6.41076 +45 2 2.89532 3.6118 17.959 -11.8167 26.1488 16.8317 +46 1 7.4312 5.4352 6.15055 3.3909 -0.433751 -53.1737 +47 2 7.92374 5.97877 6.73644 15.9967 14.3411 25.9486 +48 2 6.95714 4.77392 6.61797 -10.969 -14.5624 25.0012 +49 1 9.79304 6.98632 12.0044 -11.2776 3.50532 -30.3595 +50 2 10.3262 6.37648 11.4616 -6.26095 5.52929 9.55968 +51 2 9.10346 7.3395 11.3719 14.604 -9.64535 21.0978 +52 1 14.0819 3.68689 8.0984 5.37498 8.43639 24.1843 +53 2 13.9041 4.52495 7.65095 -1.63712 -2.30615 -0.914734 +54 2 14.2511 3.92795 9.04472 -1.39906 -3.736 -24.3353 +55 1 4.49163 17.2405 3.95076 10.4122 -13.5126 12.545 +56 2 5.41424 17.4498 3.85674 17.5711 4.37719 2.71306 +57 2 4.10795 17.4238 3.10711 -15.6864 12.0721 -17.6618 +58 1 16.4063 16.5742 10.3304 -30.4876 -1.09383 10.2792 +59 2 15.5552 16.587 10.8552 23.7267 -0.690427 -17.666 +60 2 16.1781 16.1401 9.48726 -2.06021 -0.342568 9.10707 +61 1 2.01216 4.81629 0.267482 -15.744 -7.33716 -25.0709 +62 2 2.32092 5.21812 1.07081 12.8803 9.20197 12.7852 +63 2 1.84588 5.54667 -0.35429 -3.07657 2.24499 6.46529 +64 1 11.4525 13.2643 16.3577 0.360612 25.402 13.2121 +65 2 11.0472 12.4174 16.5451 -7.76012 -9.6277 -2.94397 +66 2 11.9986 13.1376 15.5855 6.89063 -5.57893 -10.2697 +67 1 10.1527 10.9848 16.8633 -20.103 19.6526 2.73515 +68 2 10.5885 10.1542 16.8545 15.6291 -29.738 -2.50548 +69 2 9.22545 10.7635 16.7018 -0.592014 4.00252 0.856412 +70 1 11.7907 17.4531 13.47 6.77179 16.9038 -5.30963 +71 2 12.2429 16.8403 12.875 5.23267 3.61287 1.34276 +72 2 12.1771 18.3441 13.2664 -10.6628 -13.9509 7.62196 +73 1 6.44648 9.35189 12.2088 11.1766 16.4313 12.1054 +74 2 7.06476 9.1188 11.5034 -9.94127 -5.08631 1.40965 +75 2 6.99588 9.90362 12.7958 -7.62877 -4.94562 -4.27954 +76 1 16.2706 12.8594 2.68209 -1.75731 9.60563 4.91889 +77 2 17.1141 13.3556 2.57766 -16.4869 -7.21292 0.814827 +78 2 15.5397 13.5204 2.75856 19.4288 -8.85346 -2.79343 +79 1 0.706006 12.6575 5.91598 14.3848 1.31093 7.35726 +80 2 1.05127 12.3982 5.06653 10.4666 0.953953 -14.2919 +81 2 18.4268 12.7017 5.73438 -31.2224 -1.2993 2.30782 +82 1 5.26466 16.4058 18.4218 -16.1073 15.9927 3.08559 +83 2 5.67174 15.6665 17.9813 11.5666 -13.4602 -0.82172 +84 2 5.61268 16.4896 0.669718 7.09967 -3.66518 0.290508 +85 1 0.630514 7.71832 4.14439 -40.0144 -22.0429 16.8318 +86 2 18.6762 8.08291 3.48621 -5.56982 2.47832 -6.04635 +87 2 1.47362 7.93412 3.82987 48.6931 13.8203 -16.755 +88 1 3.15187 8.95984 6.48267 23.8542 8.38798 -14.0929 +89 2 3.71388 8.45844 7.06344 9.53544 -4.30832 6.22463 +90 2 2.31458 8.97258 6.8974 -32.9047 0.579586 11.7619 +91 1 7.26503 10.3427 16.2788 17.1997 0.0580756 -23.1821 +92 2 6.56569 10.7121 15.7432 -4.58149 2.66195 0.233626 +93 2 6.94547 10.3415 17.17 -9.40627 -4.59594 18.3856 +94 1 11.082 0.946861 5.00581 6.19269 9.74659 5.8053 +95 2 11.2852 1.82567 4.65658 -6.55006 -0.520752 -0.877191 +96 2 10.8571 0.430046 4.22808 -5.9868 -5.86677 -2.53499 +97 1 4.345 2.8292 13.2132 -1.27186 28.7368 -8.62995 +98 2 4.51529 3.21096 14.0791 1.17168 5.0352 0.572822 +99 2 4.2316 1.91147 13.3845 -6.13817 -32.6591 5.85186 +100 1 8.38376 10.2307 1.79685 4.09005 3.74222 -19.3624 +101 2 8.31491 10.9253 2.45197 -4.24337 3.92137 10.2746 +102 2 8.66929 9.45546 2.26885 2.27917 -12.8064 10.4703 +103 1 10.3305 1.70894 15.5022 6.01592 -1.55552 8.18831 +104 2 11.2875 1.57757 15.6324 -10.5356 -0.805047 -6.9053 +105 2 10.1546 1.87921 14.5629 5.4285 2.19916 1.25738 +106 1 2.65797 12.824 7.8537 2.67737 0.310449 -2.88199 +107 2 3.19441 13.4775 7.37699 -0.834696 -1.21778 5.43137 +108 2 1.94106 12.6113 7.24505 -1.36647 0.43678 -0.0339739 +109 1 3.78494 11.7026 5.05983 17.7759 13.7966 10.32 +110 2 3.63161 10.9725 5.64962 -3.29006 -9.81966 6.20688 +111 2 3.00915 11.823 4.52928 -13.3129 -0.91097 -10.8894 +112 1 6.77794 14.436 16.9596 -4.81268 9.99067 -5.99614 +113 2 7.54793 15.0018 17.1111 -0.926912 -4.93073 -4.17577 +114 2 6.38498 14.6674 16.0968 9.73202 -0.180074 3.30595 +115 1 14.2221 14.5157 3.27778 -13.9298 6.06594 9.9851 +116 2 13.8151 15.3779 3.06073 2.11094 -9.8452 8.88116 +117 2 13.8089 14.1856 4.11 4.80477 6.02161 -17.3229 +118 1 8.54544 18.1123 16.0497 -51.2002 16.193 -5.03192 +119 2 8.97127 17.2819 16.1484 30.3531 -21.0569 10.3371 +120 2 9.10378 0.243275 16.0887 21.8256 4.58901 -4.15396 +121 1 4.6724 1.65079 4.89395 -0.428695 -35.2982 26.3678 +122 2 3.9342 2.19791 5.10489 -21.2256 11.2309 2.3914 +123 2 5.17375 2.14476 4.28849 23.1392 22.1006 -30.0951 +124 1 14.9936 12.6291 16.4673 -19.77 11.4375 -24.1827 +125 2 14.4795 13.0601 17.1383 2.64859 2.32978 20.7439 +126 2 14.3496 12.6271 15.7247 18.4778 -8.83273 3.74622 +127 1 15.7172 18.4491 16.8771 -38.7365 1.31848 -37.9731 +128 2 16.4119 18.3751 17.4758 43.0193 1.36234 40.9307 +129 2 15.3332 17.5625 16.8778 1.44654 -2.1141 -5.88546 +130 1 1.31769 1.23679 16.6144 -6.54563 -5.62507 -9.64947 +131 2 2.12749 1.70533 16.7963 11.1847 9.69542 4.67012 +132 2 0.698368 1.60678 17.2434 -6.22801 1.29783 7.94738 +133 1 18.1828 4.42633 15.9571 -10.2445 4.38521 4.02875 +134 2 18.0727 3.95797 15.1342 -1.32851 -5.12675 -7.69371 +135 2 0.442412 4.30859 16.2307 9.57607 0.794437 2.0974 +136 1 12.2114 16.9885 16.1505 19.3184 14.9656 -43.0527 +137 2 11.4192 16.582 16.4369 -30.1172 -13.2398 21.5491 +138 2 12.0643 17.0779 15.1772 3.25614 1.68146 17.8786 +139 1 16.0795 2.58494 18.1555 11.3664 -10.2705 19.274 +140 2 15.8693 3.49863 18.3 -12.3112 17.2654 5.58069 +141 2 15.8977 2.41247 17.2454 -5.4363 -1.34473 -24.067 +142 1 6.67972 13.8354 10.1508 -8.25744 -4.72138 -13.3408 +143 2 6.54568 13.5231 11.0561 -0.87434 -6.75398 -1.82198 +144 2 6.44555 13.1152 9.51962 7.50297 7.52708 13.7797 +145 1 10.1393 18.4632 2.72581 -2.6903 -13.3312 7.25948 +146 2 10.3702 0.440572 2.04373 3.08075 7.1003 -10.4416 +147 2 9.34905 18.0295 2.38643 -2.95732 2.6687 3.95308 +148 1 3.05039 17.7207 6.12428 0.448774 -3.44066 -6.39261 +149 2 2.22716 17.4884 5.64326 9.1847 7.623 2.40325 +150 2 3.74061 17.8548 5.44564 -15.5509 -1.85687 4.81473 +151 1 12.5974 16.8374 7.98109 22.5462 3.91689 -18.138 +152 2 11.9813 16.1063 7.98041 -18.255 -3.99171 0.854341 +153 2 12.4106 17.4726 8.66951 -8.78709 2.06599 13.7307 +154 1 14.8906 15.2874 8.20197 12.2291 6.1037 -1.40009 +155 2 14.0169 15.6824 8.32954 6.14586 6.92547 -6.68196 +156 2 15.3058 15.6925 7.40177 -13.6896 -13.6819 15.1947 +157 1 17.774 18.2462 0.317021 16.5526 -0.292921 -8.65749 +158 2 18.517 17.6459 0.018512 -14.2865 26.6269 11.4024 +159 2 18.1212 0.514643 0.485201 -2.53379 -23.9559 -4.59837 +160 1 0.824062 10.4854 1.38532 29.0751 41.1299 -24.8426 +161 2 0.152225 9.85957 1.54468 -35.7643 -25.6114 8.77961 +162 2 0.463481 11.18 0.764874 10.1431 -20.9883 20.7352 +163 1 1.76832 12.2434 3.3342 -0.376699 -6.62105 -8.54196 +164 2 1.60728 11.5206 2.66813 -0.613387 21.7926 10.4725 +165 2 1.98383 13.0773 2.86566 -4.64348 -14.8628 -2.7215 +166 1 0.631416 17.2455 4.93339 -1.94983 -6.83399 6.66588 +167 2 18.8682 18.1422 4.98859 -2.83763 -23.6492 7.38562 +168 2 0.299607 16.5671 5.5918 8.11627 31.0276 -16.6779 +169 1 1.13057 0.905706 9.36586 -12.3827 -0.18715 22.5068 +170 2 1.31261 0.747855 10.3312 -4.25497 -2.51626 -23.3877 +171 2 0.268645 0.477115 9.21068 10.8181 5.54227 0.850191 +172 1 16.7346 2.37332 13.3038 3.72479 1.84576 21.5886 +173 2 16.9761 2.56684 12.4028 0.0757035 3.67621 -15.1405 +174 2 16.5678 1.42686 13.3713 -2.69734 -3.58003 -5.961 +175 1 2.71222 15.8556 12.0453 -23.2953 18.5694 10.7935 +176 2 3.02055 15.4773 12.8617 6.20357 -6.16654 7.20198 +177 2 3.26455 15.5565 11.3309 7.18341 -3.43964 -7.05157 +178 1 16.426 15.6488 6.1101 -14.7609 -25.4644 9.17481 +179 2 17.2826 15.6571 6.51544 16.1879 -4.44611 5.83009 +180 2 16.438 16.358 5.49538 -5.11113 23.225 -23.4349 +181 1 5.76882 5.13637 11.8122 -12.0704 17.5482 5.11471 +182 2 5.44081 5.9885 12.2003 4.95719 -19.5528 -5.70673 +183 2 5.01212 4.52871 11.8104 6.55972 2.89024 2.61392 +184 1 15.1343 4.86498 0.81249 17.6468 10.3526 -37.7608 +185 2 14.8624 4.60472 1.67155 -6.094 -8.43385 31.413 +186 2 14.42 5.38891 0.454388 -5.76674 3.16257 -0.979918 +187 1 16.354 16.4047 2.01729 -13.9507 10.6217 3.88258 +188 2 15.8491 16.8174 2.76015 19.926 -7.04016 -11.695 +189 2 16.7635 17.1307 1.5183 -3.64457 0.258913 2.52225 +190 1 0.229093 4.84171 3.85636 -16.5361 -39.1535 -9.01102 +191 2 0.280674 5.76384 3.97165 5.27146 43.6678 4.59383 +192 2 0.903367 4.46589 4.41298 10.8 -4.72049 2.86342 +193 1 2.98031 15.0696 15.1724 7.38994 17.2595 -26.1187 +194 2 2.78389 14.6733 16.0132 -4.59533 -4.91572 22.4357 +195 2 2.69496 16.0061 15.2442 -6.09825 -12.2809 0.399162 +196 1 1.14224 14.6486 9.53301 9.69931 -12.3423 3.57818 +197 2 2.08157 14.8372 9.66442 -5.69448 4.03807 -1.75917 +198 2 1.10168 13.6946 9.72739 -6.61933 10.5759 -2.74939 +199 1 13.5148 16.5367 11.5259 11.0739 -5.14125 9.92262 +200 2 13.0998 17.2443 11.0437 -3.0151 15.655 -8.61356 +201 2 13.0781 15.7617 11.1648 3.09342 -5.90037 -0.559148 +202 1 4.6468 1.4492 0.760442 21.9419 17.6404 -6.63386 +203 2 4.03376 2.00221 0.272437 -3.30289 2.18566 -6.21296 +204 2 4.11186 0.849122 1.26962 -7.6403 -10.762 3.4591 +205 1 1.46385 18.5705 11.8684 11.5971 1.37494 19.5738 +206 2 1.40443 0.572196 12.6059 -0.800227 -11.3118 -6.50307 +207 2 2.03902 17.8403 12.1929 -11.6325 11.1906 -9.16825 +208 1 11.4878 10.1514 4.00495 -23.562 -17.5625 40.225 +209 2 11.4445 10.4449 3.12053 -0.0273244 15.9845 -32.1431 +210 2 12.4087 10.0544 4.20335 22.0666 -0.101113 3.57488 +211 1 8.17978 12.1587 3.71493 28.653 -3.15285 -17.361 +212 2 9.01377 12.5671 3.97927 5.41625 0.887106 1.05136 +213 2 7.604 12.3558 4.43149 -23.5411 2.07968 29.6007 +214 1 14.5452 4.04195 3.30356 -17.0528 -5.31405 -8.64237 +215 2 15.1661 4.06926 4.02931 6.41379 4.8272 12.7333 +216 2 13.7233 4.44982 3.62226 2.87412 -0.159853 0.628569 +217 1 5.66111 1.64664 7.53337 47.3068 24.6854 -47.7691 +218 2 4.99385 1.2169 7.99076 -47.8059 -33.9417 34.4755 +219 2 5.55481 1.33937 6.59792 -2.0798 14.2024 17.8553 +220 1 17.8737 1.09537 4.84004 -13.6202 -14.1831 4.02096 +221 2 18.464 1.49436 4.20233 9.91759 7.15437 -5.32228 +222 2 17.8561 1.60546 5.65338 7.58498 6.35358 2.28946 +223 1 6.84561 9.39092 4.51119 3.77645 -4.79561 13.9854 +224 2 6.80242 9.62767 5.4641 3.30223 -6.77647 -16.668 +225 2 7.74702 9.0401 4.34673 -10.1352 5.61637 3.28246 +226 1 2.64818 14.8733 2.0031 -12.6643 -4.21043 8.13073 +227 2 3.39044 14.7832 2.61388 1.60205 1.10943 -1.58393 +228 2 2.93662 15.3311 1.21566 8.61024 -0.712779 -4.79925 +229 1 17.3356 12.9304 13.2091 0.397713 16.5012 -11.0143 +230 2 16.4513 13.2838 13.3976 5.15185 -2.46087 0.53778 +231 2 17.8465 13.7314 12.9621 -7.21788 -13.1567 2.02539 +232 1 14.9178 10.5628 1.45295 0.32879 33.5889 18.189 +233 2 15.3786 11.3985 1.79277 -12.1624 -32.8958 -12.3175 +234 2 13.9692 10.6935 1.62732 12.9477 -1.40805 -3.43718 +235 1 5.70482 6.69167 4.56094 -12.9541 28.0444 -8.31435 +236 2 5.76223 7.67071 4.46331 5.24004 -15.8993 1.97075 +237 2 6.3673 6.43877 5.21208 3.70858 -3.97365 0.601716 +238 1 7.97185 8.33683 10.3069 8.6941 -15.2025 -3.68424 +239 2 8.60404 8.92215 9.84221 -9.13329 -6.11086 -5.89913 +240 2 7.51742 7.70171 9.70626 6.59476 18.8917 -0.227694 +241 1 13.4177 18.464 5.71198 21.9916 6.6123 -14.6219 +242 2 12.6947 0.421284 5.51228 -9.11836 -2.12279 2.23123 +243 2 13.1839 18.0173 6.51737 -9.90438 -14.4062 13.6987 +244 1 0.0221035 2.62655 0.261444 12.6472 -47.1951 11.8456 +245 2 17.7527 2.75577 18.6598 -10.3686 10.7513 -7.61459 +246 2 0.546882 3.40438 0.188377 7.87852 33.0005 -3.15527 +247 1 12.8067 10.9927 9.75832 44.9647 -24.4125 8.46131 +248 2 11.8751 10.9314 9.65932 -31.4773 -7.30673 -3.09024 +249 2 13.1121 10.0761 10.034 -17.0663 24.2241 -8.13324 +250 1 0.673563 12.1459 11.0385 -14.9158 10.2345 17.3916 +251 2 18.3756 12.1565 11.2954 6.68564 0.0119082 -11.299 +252 2 1.10384 12.3853 11.8646 9.18612 4.40652 0.693569 +253 1 5.14721 7.33361 13.3929 15.7357 3.63047 1.84442 +254 2 5.59488 8.13358 13.0475 0.482915 -12.4288 -2.35902 +255 2 5.71887 7.03407 14.1269 -8.93121 6.52874 -3.37327 +256 1 1.18567 6.84505 11.8697 14.6786 34.5125 12.17 +257 2 0.393465 7.21987 11.4553 4.74321 -4.21777 2.31791 +258 2 1.70022 7.64215 12.2222 -16.972 -31.3024 -13.5319 +259 1 15.4816 9.69158 12.3277 9.90347 -39.8653 -1.57959 +260 2 15.3406 10.5924 12.1653 -13.2531 41.4735 -11.5871 +261 2 15.406 9.62533 13.2698 1.46249 -6.23285 16.1579 +262 1 16.5413 12.6347 5.5059 7.75274 -6.4804 14.118 +263 2 16.3104 13.5445 5.70094 -2.97213 12.2972 0.10227 +264 2 16.3923 12.5258 4.56955 -2.98329 -0.0504447 -18.3871 +265 1 6.30461 9.82716 0.0624729 6.72618 23.4574 16.6882 +266 2 5.51437 10.3287 0.304315 -0.069722 -0.440899 2.51054 +267 2 6.96842 10.0501 0.765687 -11.6212 -9.0506 -14.676 +268 1 12.2588 6.10042 4.03099 15.0483 24.7381 -3.94445 +269 2 12.3021 6.98896 3.58767 -5.34003 -28.327 1.95056 +270 2 11.3325 5.86569 4.06669 -11.2394 -4.89225 -2.88949 +271 1 0.336489 12.822 0.136131 -4.0328 -4.68121 -1.73262 +272 2 -0.0692718 13.3776 0.815875 4.64589 5.49593 0.971726 +273 2 18.45 12.9344 17.9884 -7.92492 5.13291 -5.47118 +274 1 3.58866 18.6351 8.62238 -6.65617 9.61834 5.79691 +275 2 3.41901 18.3768 7.70859 0.297411 -7.32139 -0.213682 +276 2 2.71275 0.31261 8.92207 15.7588 -5.16119 -5.17535 +277 1 7.50496 17.418 4.49772 -12.5742 -28.6928 8.65377 +278 2 7.55283 18.3491 4.58726 6.16277 33.1384 2.27358 +279 2 7.74423 17.2559 3.59134 -1.33953 -2.22923 -11.883 +280 1 9.26392 17.1331 12.2129 -23.7136 4.99112 -6.35848 +281 2 9.34774 16.2465 11.866 0.0093118 -9.2577 -7.50778 +282 2 9.98892 17.2487 12.8038 23.7327 3.38143 15.862 +283 1 13.3751 13.0337 7.97577 10.7478 10.6887 -13.5108 +284 2 13.3787 12.2298 8.50206 6.89696 -2.46192 7.10708 +285 2 14.2592 13.4885 8.01338 -22.4634 -9.00878 7.77512 +286 1 14.8592 2.99547 15.3735 -5.27851 1.66435 23.9116 +287 2 14.1885 2.32373 15.2402 -1.63897 -5.65445 -5.41614 +288 2 15.4149 3.00295 14.6023 9.16888 -1.78425 -15.607 +289 1 9.86925 15.6154 16.9672 4.33331 -1.89849 4.26663 +290 2 10.4152 14.8537 16.7052 -6.80597 -3.90746 -0.277805 +291 2 9.57771 15.4416 17.8827 0.419377 0.378738 -9.64067 +292 1 11.2678 8.44973 16.5939 -8.08747 -14.0791 2.0813 +293 2 10.6693 7.85604 16.0792 7.94549 12.4538 10.9378 +294 2 11.4172 8.01973 17.4598 -1.80582 0.647834 -14.6449 +295 1 3.91551 18.1683 16.8005 9.39931 12.2215 14.3903 +296 2 4.49606 17.6509 17.3756 -3.52447 -10.1131 -6.81095 +297 2 3.95318 0.38369 17.2365 -5.94998 0.470214 -7.14863 +298 1 2.19966 4.20574 8.91394 -16.952 6.25086 -28.7566 +299 2 3.11163 4.1112 8.67966 19.1354 -3.54458 -0.459765 +300 2 2.10589 3.95692 9.81579 -0.00585893 -3.49833 31.5267 +301 1 9.86514 10.3731 9.72031 15.6542 -41.5135 2.74879 +302 2 9.61489 11.2182 9.40808 -14.4527 35.546 -8.7168 +303 2 10.0569 10.3888 10.6595 -0.965326 6.48855 10.4451 +304 1 9.65603 0.92083 10.8651 15.4128 -5.93628 -1.69563 +305 2 9.35399 0.0448876 11.1808 -6.92756 10.8331 -8.061 +306 2 9.08478 1.27687 10.159 0.925367 -10.2687 5.27886 +307 1 9.17601 15.08 10.2001 28.4704 15.1584 7.58672 +308 2 8.86011 15.9493 9.94215 -4.94078 5.46469 -8.90142 +309 2 8.40516 14.5378 10.1682 -22.1716 -15.7686 -1.61012 +310 1 0.908908 9.65777 10.2661 1.02783 -39.6886 -13.0526 +311 2 0.968686 10.5462 10.5861 7.37828 17.5094 1.10535 +312 2 1.79128 9.34954 9.98968 -11.6106 9.29057 7.26807 +313 1 16.9796 4.82858 8.10785 29.2892 -10.1291 -25.9715 +314 2 16.4029 5.49318 8.42182 -23.755 22.5857 11.698 +315 2 16.8784 4.07707 8.6652 -3.89501 -13.8815 13.5617 +316 1 14.7893 14.6979 0.173135 5.39554 -7.96858 -12.7144 +317 2 15.0505 15.3823 0.785417 9.36392 5.93735 12.263 +318 2 13.9789 14.3219 0.494521 -15.109 -8.03615 11.244 +319 1 3.74323 11.0124 9.54886 4.38849 -4.14114 10.1409 +320 2 3.63158 11.395 10.4392 1.27308 -1.67175 -3.21468 +321 2 3.24423 11.5652 8.93525 -2.74645 9.31742 -2.2917 +322 1 11.2573 10.7534 1.46897 -2.74628 -20.4518 -2.00657 +323 2 11.6064 11.5358 1.05536 3.45865 20.4344 -8.16659 +324 2 10.3358 10.6724 1.18755 -1.77969 3.26872 -0.743535 +325 1 13.1779 7.19199 12.7182 14.2184 -9.05364 3.75753 +326 2 14.115 6.87295 12.7816 -17.4164 8.42328 -3.38551 +327 2 12.6212 6.40428 12.8017 3.66516 -2.90974 1.8722 +328 1 9.6094 1.86333 0.961036 -1.66559 10.1622 -20.0065 +329 2 8.74982 1.7634 0.476399 21.9169 -1.84649 8.18396 +330 2 10.2659 2.29351 0.366445 -15.6421 -6.48907 5.12748 +331 1 10.6591 13.4925 4.58018 -19.1141 -0.630091 -16.1529 +332 2 11.5305 13.1262 4.70232 12.5696 -8.82773 5.21944 +333 2 10.586 14.1761 5.24203 -0.728557 4.94256 14.6221 +334 1 14.495 1.73909 10.9749 -8.14936 -7.82556 -5.33359 +335 2 15.2253 1.30703 10.5146 2.44721 2.03735 2.44955 +336 2 14.6402 2.68373 10.8341 0.821335 1.15578 7.11863 +337 1 14.5247 12.1307 11.6327 6.29346 4.76638 51.459 +338 2 15.3146 12.4097 11.1999 18.4985 9.73575 -23.8815 +339 2 13.8662 11.9319 10.9987 -20.1843 -8.01501 -29.1382 +340 1 8.1934 5.08514 9.85848 20.6286 -7.50881 -18.2265 +341 2 7.39102 5.12991 10.3666 -14.5844 -3.05188 8.40055 +342 2 8.26178 4.1705 9.49849 -5.86813 14.6103 10.9415 +343 1 1.56363 16.9354 18.4208 -1.17306 -23.9048 5.52961 +344 2 2.13897 17.2639 17.7268 3.56106 5.06395 -9.30964 +345 2 1.54669 15.9596 18.2963 3.84009 16.9778 0.440392 +346 1 1.49268 17.3196 15.3241 -27.5122 8.95969 8.58328 +347 2 1.46041 18.2525 15.6844 -4.86102 -31.3543 -7.55486 +348 2 0.570896 16.9106 15.346 29.8648 20.9529 0.539048 +349 1 3.59911 5.78915 6.06648 9.03859 -15.9659 -5.84137 +350 2 3.1214 6.40715 6.60976 -11.746 7.94276 10.4286 +351 2 4.15987 6.31414 5.47841 1.03618 -2.86439 -0.897012 +352 1 12.5136 9.4824 14.2234 -14.5482 39.9006 11.9441 +353 2 12.9252 8.74241 13.842 20.5687 -36.5434 -22.703 +354 2 12.2915 9.17254 15.1019 -4.72781 -1.84288 9.93497 +355 1 4.05984 15.2792 6.9471 -25.1121 -18.1042 13.4141 +356 2 3.54373 16.0393 6.6659 -0.213909 7.77754 -0.115815 +357 2 4.94872 15.4739 6.70425 29.3053 8.29501 -4.075 +358 1 0.70733 8.67925 15.049 -6.53077 -6.52645 2.33041 +359 2 0.403057 9.59211 15.0995 2.0449 7.24241 -1.44461 +360 2 1.39578 8.67212 14.3782 6.73055 2.7204 -4.7895 +361 1 12.9505 8.27543 10.2426 2.52256 -9.36522 19.2887 +362 2 13.7222 7.81068 9.89429 1.56507 0.683648 -5.24915 +363 2 12.8789 7.88642 11.1491 -0.00217653 14.5673 -16.6218 +364 1 15.3477 7.80216 3.55401 -12.532 5.83489 -12.7989 +365 2 14.4906 7.48222 3.33103 -16.8871 -2.65253 -29.4538 +366 2 15.2947 7.61797 4.46883 25.5814 -3.41235 36.6493 +367 1 17.266 6.70187 0.000674068 12.1195 -8.95496 8.26487 +368 2 16.7457 6.00049 0.395257 -2.87342 -9.15243 0.336143 +369 2 16.622 7.35704 18.4101 -17.4752 15.3525 -8.08793 +370 1 8.88335 6.95399 7.81342 26.8473 24.5973 -5.8387 +371 2 9.80542 7.33522 7.87938 -25.1058 -10.3372 -2.45861 +372 2 8.7714 6.40725 8.58367 -2.11125 -14.3958 16.4377 +373 1 12.3879 0.548843 1.24082 4.42765 -0.472301 -1.45686 +374 2 13.3265 0.730859 1.40339 -2.38609 2.78881 -0.689397 +375 2 12.2563 0.636326 0.292606 2.56041 -5.4085 -0.678049 +376 1 5.63248 15.1125 14.5468 -9.48886 -16.8407 5.02155 +377 2 4.69503 15.2624 14.7723 5.83199 -5.28539 -1.87026 +378 2 5.99589 15.9615 14.314 8.44734 16.7096 -6.42729 +379 1 3.85575 6.39433 1.75493 1.50274 -8.79363 8.51258 +380 2 3.48975 7.20754 1.41538 -8.87879 17.021 -2.96274 +381 2 4.03803 6.55873 2.69128 -1.36395 1.28851 -4.88856 +382 1 3.93631 11.5299 12.3893 -8.10483 -0.317118 -5.66906 +383 2 4.80663 11.9435 12.4577 -3.51298 -1.2689 0.972005 +384 2 3.32279 12.1457 12.8171 1.30391 -5.08042 -1.13556 +385 1 5.30379 3.85961 15.861 3.26535 -66.7729 -21.4105 +386 2 5.99128 3.21668 15.5051 -18.0074 17.9789 14.3955 +387 2 5.71814 4.68422 15.8683 22.7973 48.3912 1.26107 +388 1 14.279 10.1761 4.52146 -28.2637 29.6843 37.5781 +389 2 14.4726 9.82647 5.40905 -2.50301 -0.0307068 -4.88302 +390 2 14.7482 9.65242 3.92054 26.3189 -27.9191 -30.9088 +391 1 7.73542 17.3919 9.15036 20.9187 -26.1564 3.32362 +392 2 6.89787 17.6412 9.51878 -14.391 11.6651 3.78997 +393 2 7.98556 17.9488 8.40931 -4.18052 11.5531 -5.69175 +394 1 4.50439 14.5239 3.99264 11.0977 -23.3764 -48.4991 +395 2 4.56306 15.4325 4.20277 -1.38797 35.5351 15.6514 +396 2 4.31322 14.0314 4.76491 -6.35847 -16.1784 30.998 +397 1 14.1606 7.45193 15.811 -24.1382 -9.56247 -10.586 +398 2 15.0553 7.36431 15.524 24.9604 -3.00047 -8.7167 +399 2 14.2305 7.91189 16.6334 1.28104 8.01927 19.5585 +400 1 2.99693 18.3516 1.90386 -17.8633 -43.3253 -26.4279 +401 2 2.47403 17.7132 1.31624 19.6124 26.5697 18.0429 +402 2 2.33007 0.205152 2.36966 -11.145 11.7012 10.1025 +403 1 8.00896 1.59538 4.54643 -14.6935 -3.1209 6.18761 +404 2 7.42733 1.99671 3.8763 8.34922 -0.442348 -1.34208 +405 2 8.90764 1.54031 4.21745 2.64121 3.0498 -7.75206 +406 1 2.41984 14.15 17.6911 38.7391 17.8224 -8.42313 +407 2 1.65201 13.6768 17.9262 -26.9962 -21.4224 14.4939 +408 2 3.15619 13.6354 18.0755 -0.305296 5.75785 -2.4818 +409 1 0.881322 1.80893 13.8899 -12.9164 4.63859 7.1799 +410 2 0.998981 1.67187 14.8549 -5.47541 -0.367675 -15.7697 +411 2 18.568 1.96442 13.7158 18.7475 -1.65173 8.16576 +412 1 4.35626 0.108756 13.8915 -10.9503 4.16473 7.68997 +413 2 5.20313 18.36 13.6952 15.0207 -4.30703 2.98167 +414 2 4.18562 18.5651 14.8318 -0.53115 -1.77986 -5.89667 +415 1 7.21985 0.783193 18.3638 -3.94277 -6.88163 -25.1551 +416 2 7.12969 0.383485 17.4575 9.77138 9.98351 24.3944 +417 2 6.41237 1.28912 18.5059 -6.03182 -4.67978 5.08395 +418 1 15.9996 18.4041 13.9383 18.1315 -1.4443 -10.5581 +419 2 15.071 18.4425 13.7445 -14.3326 2.53282 3.85714 +420 2 16.1651 18.6473 14.8506 -8.9044 -3.87569 12.2679 +421 1 10.1939 4.54115 16.2821 35.3159 -4.68875 2.87762 +422 2 11.1919 4.40884 16.3129 -34.2522 14.5881 -3.55905 +423 2 9.86192 3.67371 16.0442 -3.43039 -7.24249 -0.81883 +424 1 15.9323 17.7355 4.44233 22.6638 -20.6434 -12.8847 +425 2 16.5412 -0.18272 4.5755 6.4476 10.7336 -1.45992 +426 2 15.0915 18.0468 4.70328 -34.4096 13.9436 14.4512 +427 1 6.99117 17.4686 13.8836 -42.0334 -7.7574 -17.1448 +428 2 7.47631 17.7428 14.6303 20.6357 14.1189 34.523 +429 2 7.65356 17.3815 13.215 15.8945 -3.28854 -19.4769 +430 1 13.2291 6.49408 6.5607 17.0277 2.09005 0.593761 +431 2 14.1816 6.76782 6.52286 -25.3304 -6.60509 -4.73803 +432 2 12.9166 6.35235 5.64754 5.89534 0.461784 7.57918 +433 1 7.85324 2.32148 9.35275 5.46391 6.9162 26.9577 +434 2 7.3686 2.17076 10.1976 2.69269 5.61176 -14.2633 +435 2 7.26481 2.08775 8.6472 -14.0957 -9.57593 -14.6111 +436 1 15.2023 14.7793 13.7187 7.74208 -16.2001 -4.59991 +437 2 14.8319 14.9596 14.5759 -4.08925 6.59301 14.3355 +438 2 15.0747 15.5488 13.1771 -7.6118 10.0658 -7.58078 +439 1 9.41047 8.32341 3.83123 -6.47708 13.1987 -5.34522 +440 2 10.2452 8.80483 3.85219 3.73168 3.01968 4.76716 +441 2 9.63137 7.40393 3.95808 -1.29777 -11.5098 0.542939 +442 1 17.7649 13.5922 16.3898 -11.4367 -25.6902 16.7919 +443 2 16.7908 13.5407 16.3666 6.32242 -2.67761 -0.626712 +444 2 17.9873 14.3645 15.8914 0.275374 22.0623 -11.5119 +445 1 4.92213 10.5724 2.8597 -4.83644 2.51404 -15.3254 +446 2 5.59736 10.2151 3.4378 8.5726 -2.027 3.49443 +447 2 4.66951 11.4171 3.23999 1.02108 -1.77966 3.70944 +448 1 3.74742 8.38157 10.0278 -2.2319 9.94706 -11.0912 +449 2 3.89489 9.30484 9.7273 -4.74563 -10.9217 8.16333 +450 2 3.84233 8.40088 10.9831 -0.997449 0.744123 6.62097 +451 1 15.9666 6.96875 6.01253 -14.8276 15.8227 3.08109 +452 2 16.7817 7.37259 6.30064 12.9112 7.94175 5.43996 +453 2 16.2196 6.12219 5.66656 5.41287 -21.5059 -0.527712 +454 1 15.1391 7.15478 9.02923 3.95319 -30.3017 38.192 +455 2 15.9165 7.52141 9.44882 9.73374 3.98045 10.059 +456 2 15.0698 7.60427 8.22918 -5.81948 28.1077 -46.3627 +457 1 6.22822 12.9188 12.7298 1.31868 -8.19268 -13.1839 +458 2 6.88351 12.2656 13.01 8.10485 3.82836 6.8834 +459 2 6.11855 13.5785 13.4162 1.19396 9.04898 12.3458 +460 1 12.1253 4.52441 13.1066 -23.5121 -14.293 -11.093 +461 2 12.4631 4.60406 14.0095 -9.44452 -2.69015 3.06865 +462 2 11.2831 3.97256 13.0795 31.8956 18.265 6.80246 +463 1 11.4055 8.12657 7.94639 -16.7563 2.96014 -17.3287 +464 2 11.9383 7.50834 7.43372 10.7385 -1.00284 -0.366803 +465 2 11.8652 8.24712 8.77366 5.83315 -1.26494 14.2429 +466 1 17.1037 10.8819 7.56719 -22.1575 4.54299 3.0458 +467 2 17.7705 10.2842 7.28531 25.0286 -24.4015 -2.83309 +468 2 16.8908 11.3655 6.76798 -3.05919 12.9941 -4.73253 +469 1 5.25302 18.1256 10.9232 26.818 -0.191878 -4.18594 +470 2 4.8269 17.8089 11.6994 -14.1597 -10.1429 18.6642 +471 2 4.64144 17.9747 10.2197 -19.8227 3.49229 -23.3423 +472 1 7.59833 17.4619 1.74995 8.37542 2.1771 -36.4257 +473 2 8.02215 16.748 1.21035 -16.0406 12.4022 13.5887 +474 2 7.374 18.1677 1.08602 7.01745 -13.9463 17.8331 +475 1 1.92633 12.907 13.6044 0.0880561 -5.46821 -16.7511 +476 2 1.47807 12.3822 14.2652 -4.39349 -7.86198 7.054 +477 2 2.32754 13.632 14.072 3.07665 17.0427 10.8635 +478 1 9.50987 6.80039 14.836 2.18935 -20.8269 12.8739 +479 2 9.79082 5.96037 15.3114 -4.54962 20.4196 -21.9392 +480 2 9.66995 6.7436 13.8735 6.47407 0.337666 8.03802 +481 1 15.2827 4.32341 10.7768 10.307 9.68599 -4.89646 +482 2 16.2397 4.0919 10.6916 -21.0983 9.39835 9.69703 +483 2 15.2266 5.10894 11.3663 5.46907 -15.4805 -5.79884 +484 1 11.3016 6.20596 0.140794 12.6043 6.09542 0.747046 +485 2 11.4786 5.29078 18.6344 12.8703 -22.3778 -2.75052 +486 2 10.381 6.25156 -0.0726873 -21.1699 14.4442 -0.985902 +487 1 -0.0715916 11.4097 14.9721 22.1692 -7.15633 35.3796 +488 2 18.1992 11.7732 14.1947 -21.0416 8.6568 -29.4322 +489 2 -0.201181 12.1402 15.5966 -0.594523 -4.50066 0.166015 +490 1 7.04588 9.27411 7.30476 9.145 16.929 -11.701 +491 2 6.64583 8.45304 7.57308 -6.76023 -15.305 10.0219 +492 2 7.98749 9.10222 7.20319 2.10913 -2.81405 2.65036 +493 1 18.3255 15.3308 12.2943 -10.9271 3.22482 1.76971 +494 2 0.551901 15.6023 12.004 16.2571 0.370549 -2.10144 +495 2 17.7334 15.6802 11.6169 -1.97195 2.58378 -3.71708 +496 1 16.5011 4.39937 5.27673 4.48444 11.2976 -56.5136 +497 2 16.7777 3.84422 5.96849 7.0389 -19.8316 37.8082 +498 2 17.2036 4.29545 4.59204 -6.79319 11.0559 14.2779 +499 1 17.7009 3.16012 10.7623 -11.0785 -13.2259 -8.21854 +500 2 -0.0365931 3.41438 10.9472 14.4195 -1.11458 2.04579 +501 2 17.6933 2.32175 10.2562 4.60522 6.17753 6.57508 +502 1 12.2846 -0.0106908 10.1146 7.09195 -37.1879 -10.2172 +503 2 11.3926 0.256016 10.2673 -25.9358 14.4274 7.98014 +504 2 12.8288 0.732071 10.298 19.2326 28.445 5.65892 +505 1 10.3866 9.75519 12.5017 -6.95633 -10.4248 -20.8372 +506 2 11.1983 9.82383 13.0055 7.4239 -2.70171 9.41801 +507 2 10.3064 8.80301 12.2683 1.05955 14.1529 10.144 +508 1 0.648708 2.774 7.07027 -1.36725 -4.55963 12.8723 +509 2 0.490272 3.61188 7.51443 -2.95105 4.17746 -2.75047 +510 2 1.10621 2.25999 7.75495 -4.79333 -3.92365 -3.87978 +511 1 0.307244 15.292 6.87913 -0.83379 49.2439 44.5727 +512 2 0.652444 15.3347 7.80405 -9.58611 -2.1659 -14.8737 +513 2 0.567348 14.4512 6.61032 15.5663 -52.8882 -22.8213 +514 1 17.056 6.99125 15.1184 -7.99596 0.858836 -4.56633 +515 2 17.7814 7.62276 14.9808 0.742784 -5.19204 3.90514 +516 2 17.4035 6.24942 15.6288 5.94943 -0.679765 0.413052 +517 1 9.13726 12.4999 8.01885 37.0353 0.885775 16.8739 +518 2 9.52568 11.8572 7.39973 -10.6447 2.68521 -0.695331 +519 2 8.21726 12.5875 7.87097 -30.0746 -3.81245 -10.8301 +520 1 1.21553 1.74407 2.88052 -2.59699 -2.39415 1.38589 +521 2 0.835324 2.14494 2.08419 1.70776 2.79001 2.24225 +522 2 1.71989 2.41102 3.3678 0.071784 1.92406 -2.09937 +523 1 4.07628 15.1457 9.88397 17.4433 -7.82557 -1.54586 +524 2 4.111 15.2412 8.92029 0.253189 0.655179 -3.36934 +525 2 4.94389 14.7737 10.148 -8.68797 4.30724 -10.2942 +526 1 7.35101 2.21809 14.6867 -7.35168 5.20952 -5.71558 +527 2 7.12719 1.57839 13.9999 0.606569 0.313122 2.88765 +528 2 7.62455 3.00796 14.1978 2.82745 -2.40467 5.3071 +529 1 18.457 14.6023 2.16488 -22.5257 23.4253 1.52633 +530 2 0.650438 15.0238 2.37846 9.31401 -4.06208 0.652559 +531 2 17.8015 15.3468 2.21006 9.59865 -20.266 -2.54542 +532 1 9.9778 2.69966 12.9163 0.655502 16.6224 11.2027 +533 2 9.96654 2.13525 12.1425 -5.01566 -7.38072 -9.38582 +534 2 9.27217 3.36428 12.8011 2.98946 -10.098 -0.342741 +535 1 2.95791 8.92102 13.0894 10.3197 8.62466 2.37945 +536 2 3.25022 9.8484 12.9226 -2.55555 -16.3803 0.657875 +537 2 3.7553 8.44758 13.4136 -17.8894 4.38499 -5.11642 +538 1 3.26012 8.5452 3.75851 7.68136 4.64814 -61.3797 +539 2 3.65213 9.34274 3.2957 -8.84339 -23.8918 18.3111 +540 2 3.19772 8.72964 4.66662 3.169 13.2307 40.2657 +541 1 5.70723 7.22602 8.61089 15.0471 5.15238 -9.7988 +542 2 5.61347 6.27934 8.4361 -3.3163 0.301479 7.52532 +543 2 4.97449 7.5436 9.15453 0.52499 -8.4302 1.10573 +544 1 14.8706 1.4621 1.8863 1.70998 27.5213 20.9307 +545 2 14.7201 2.23316 2.46749 -8.28585 -15.753 -0.675778 +546 2 15.5631 1.82311 1.33978 3.90729 -10.8233 -20.0391 +547 1 8.4891 15.095 0.746196 -1.67248 3.44686 2.60315 +548 2 9.16152 15.1411 1.43932 5.44244 -6.16758 -2.29782 +549 2 7.78914 14.5375 1.12422 -1.25934 1.00196 -2.01266 +550 1 15.531 1.37665 7.20033 20.0832 14.6351 13.3031 +551 2 14.8916 0.843079 6.76136 -18.4007 -14.9103 -14.8508 +552 2 15.066 2.19014 7.43626 -3.82192 3.26637 1.54172 +553 1 5.03616 12.9919 18.445 -16.5564 -3.92778 -1.34985 +554 2 5.49952 13.0651 0.633359 3.65082 -0.909975 11.8673 +555 2 5.58799 13.4788 17.838 5.35286 -1.67587 -4.32886 +556 1 15.4004 8.57696 18.1096 -13.5133 -17.3986 23.7812 +557 2 15.6963 9.177 17.4428 12.1428 17.8023 -17.443 +558 2 15.2132 9.11981 0.25138 2.83515 1.87454 -5.46736 +559 1 12.0742 3.0873 18.3015 -13.0771 12.9456 1.32203 +560 2 12.4416 2.71193 0.467697 5.19488 -4.15516 -6.31478 +561 2 12.3414 2.59119 17.5164 7.34103 -8.20972 9.84797 +562 1 13.1603 12.6784 5.14975 4.6094 5.88635 0.276196 +563 2 13.6665 11.971 4.72065 -1.49243 -3.38503 8.68718 +564 2 13.2851 12.6103 6.1136 1.29016 -0.295852 -5.09341 +565 1 6.06548 7.22062 0.130395 -10.0215 14.1887 -9.78073 +566 2 5.90478 8.1622 -0.126677 10.3505 -23.4507 13.8616 +567 2 5.20282 6.91875 0.452817 7.86884 -4.47391 0.318594 +568 1 17.6551 15.8705 14.9463 -5.31761 6.83655 -25.2986 +569 2 16.721 16.066 14.8837 -6.35164 3.20497 21.4179 +570 2 17.8286 15.8261 13.9944 18.3936 -6.902 3.79502 +571 1 13.1598 0.895115 16.6829 -10.2787 13.0231 -1.21317 +572 2 14.0985 0.838925 16.8484 11.7714 -2.60716 3.82434 +573 2 12.9094 -0.0108285 16.49 -7.09766 -5.67505 2.02872 +574 1 10.9245 14.5193 7.39494 -10.4099 -10.8827 23.6465 +575 2 10.1209 14.2503 7.91799 23.546 5.98273 -19.3945 +576 2 11.6246 13.8906 7.65805 -5.45953 8.29317 -8.96944 +577 1 17.5666 8.45977 2.1077 -2.45541 -18.4017 -7.84499 +578 2 16.6916 8.4078 2.54921 14.2221 -0.924117 -8.74119 +579 2 17.6058 7.68446 1.4828 -2.53767 24.5137 15.8214 +580 1 12.3693 7.85876 1.99742 11.9287 1.39128 11.652 +581 2 11.9574 8.70597 1.81668 -2.84663 4.1279 -5.57453 +582 2 12.0661 7.22941 1.33154 -5.87406 3.00715 -1.1515 +583 1 12.0244 14.6632 10.3909 28.0505 -1.98221 6.53788 +584 2 12.2154 13.9026 9.84664 0.841551 -5.23881 -6.52272 +585 2 11.0973 14.8027 10.3697 -37.2752 0.615569 -5.61626 +586 1 6.83101 6.95959 15.54 -26.922 -25.3261 -7.84618 +587 2 7.74646 6.93869 15.3131 28.0025 5.72032 -4.23149 +588 2 6.70706 7.70294 16.1074 0.47288 18.1258 13.2198 +589 1 7.99181 4.56873 13.323 -17.7662 10.8645 -2.94772 +590 2 7.11502 4.75523 12.8947 23.3848 -2.11675 2.9311 +591 2 8.34221 5.42155 13.6369 -8.03699 -10.5621 -3.57795 +592 1 13.4097 12.1854 14.3195 -5.65215 6.28756 1.83858 +593 2 13.0403 11.2921 14.2436 5.24433 -3.00833 -1.58816 +594 2 13.8498 12.3732 13.4771 -2.55607 -2.02901 -2.35573 +595 1 14.6454 9.43305 7.28195 10.7596 15.6461 6.41649 +596 2 15.5174 9.89596 7.36949 -20.7431 -7.51972 6.68313 +597 2 14.0059 9.84843 7.89782 12.5114 -5.65293 -10.9965 +598 1 12.693 16.9181 3.21868 4.13721 -47.3842 -7.97708 +599 2 12.7878 17.338 4.04875 4.47204 15.8163 32.4195 +600 2 12.4838 17.5994 2.61833 -10.0532 31.8516 -27.8744 +601 1 1.00841 7.13021 17.3596 12.9632 -6.47488 11.204 +602 2 0.140567 7.22584 17.7618 -2.41623 -7.13214 2.78808 +603 2 0.956632 7.61621 16.5408 -0.0488819 7.87685 -11.8994 +604 1 12.917 4.94058 15.6965 -33.9833 6.00302 -1.61153 +605 2 13.6432 4.4005 15.9475 28.608 -13.7192 2.54357 +606 2 13.1955 5.85458 15.7909 9.71851 9.87704 0.635703 +607 1 2.3887 3.3689 5.15584 14.955 -15.9692 -52.0278 +608 2 1.80093 3.08916 5.81858 -25.593 -10.9876 33.4797 +609 2 2.79381 4.15677 5.46164 14.8077 31.4017 13.6729 +610 1 8.27435 11.0395 13.6153 -37.0795 23.6732 -65.6931 +611 2 8.36475 10.9269 14.5167 14.9976 -12.7369 63.1872 +612 2 9.08207 10.7919 13.1709 13.5323 -11.5041 2.55762 +613 1 12.9711 1.50053 13.2758 -7.16838 -21.0368 21.1096 +614 2 13.525 1.50324 12.5105 16.6349 2.94139 -20.1138 +615 2 12.6114 2.3778 13.3258 -6.20414 13.0805 -2.33086 +616 1 6.55993 13.5741 2.17335 4.5265 3.63418 -23.4358 +617 2 5.93511 13.8533 2.83279 -12.7543 7.85744 13.7798 +618 2 7.20659 13.0527 2.65116 1.25385 -4.10852 0.808212 +619 1 15.8831 6.47501 12.6409 22.0814 4.72601 -0.603906 +620 2 16.4738 6.98335 12.028 -14.2245 -11.2946 14.6347 +621 2 16.3705 6.43226 13.5009 -10.5632 5.96191 -15.5708 +622 1 16.8031 0.705923 9.56407 -2.28595 11.5891 -8.26827 +623 2 16.6552 18.4511 9.84906 2.3526 -17.7501 5.98934 +624 2 16.3731 0.773302 8.69375 1.62838 3.03603 0.698224 +625 1 6.10625 11.6157 8.28914 -3.08711 55.9701 7.34602 +626 2 5.36711 11.2964 8.79127 -16.3164 -7.54559 6.80515 +627 2 6.5283 10.8686 7.94164 19.8706 -42.6353 -12.8098 +628 1 2.81358 8.70539 0.376179 36.8039 -5.08598 16.3747 +629 2 2.33554 8.23944 18.3571 -22.6922 -9.90678 -17.9478 +630 2 2.28148 9.42572 0.700092 -14.5476 7.98537 3.82577 +631 1 10.114 10.4289 6.56839 -5.48816 -6.21666 7.2072 +632 2 10.5648 9.70982 7.03635 1.99723 -0.0329781 -1.13968 +633 2 10.3487 10.347 5.64237 7.8387 0.67993 -6.97128 +634 1 6.81211 15.7679 6.65103 -0.348958 5.58939 -1.23617 +635 2 7.12762 16.1335 7.48534 -0.336507 -3.46393 3.99871 +636 2 7.12562 16.4168 5.9986 -1.75978 -6.48118 -4.29666 +637 1 6.49059 12.9347 5.74014 0.722488 11.3509 6.39713 +638 2 6.52544 13.8593 6.05125 4.61742 -7.45139 -3.43251 +639 2 6.13117 12.4341 6.48422 -0.637044 1.07223 -0.836688 +640 1 16.7722 12.5296 9.75372 -10.3378 8.80589 22.9139 +641 2 16.9709 11.8837 9.07779 5.41942 -3.21474 -11.15 +642 2 17.3199 13.309 9.62307 0.866334 -2.28521 -6.10033 +643 1 6.18734 2.89369 2.76381 6.70118 21.5641 -20.0406 +644 2 6.53969 3.77128 2.46465 -8.05809 -16.0544 14.4298 +645 2 5.6766 2.59589 1.99155 1.09601 -8.68373 7.94101 +646 1 10.8178 3.09588 3.24672 1.33393 -8.05069 0.148042 +647 2 10.2056 3.80475 3.46561 0.323029 3.07521 -1.63087 +648 2 10.3998 2.55919 2.55618 -0.935454 8.00813 2.52947 +ITEM: TIMESTEP +70 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.83052 6.78564 17.8747 4.81039 14.7119 7.93216 +2 2 8.02044 7.08583 18.306 -2.95347 -6.04078 -1.17349 +3 2 8.57794 6.09723 17.2713 -4.49598 -11.7014 -7.63976 +4 1 0.124161 8.31212 6.74558 -2.09679 -1.27724 -21.4903 +5 2 0.320991 8.02726 5.80661 -3.30063 7.0305 29.7013 +6 2 0.593986 7.72695 7.35611 1.84479 -1.64007 -4.64643 +7 1 8.55341 0.214487 6.89794 4.20955 -4.60902 11.3327 +8 2 9.45965 0.255338 6.58274 3.95615 -0.229119 -0.443755 +9 2 8.09377 0.850204 6.35793 -6.3823 8.35705 -5.64785 +10 1 6.52177 1.69631 11.7106 -29.0447 -4.52087 -3.66773 +11 2 5.85029 2.25877 12.1616 13.2184 -10.2105 -7.98022 +12 2 6.00884 0.936302 11.3174 15.6542 21.0994 14.986 +13 1 6.92822 5.5902 2.37948 23.4336 -17.8876 -5.1013 +14 2 6.5261 5.8779 3.18071 -18.514 8.45901 19.042 +15 2 6.74676 6.28055 1.75003 -1.36947 6.04298 -15.8103 +16 1 16.1916 10.2374 16.1412 -24.0328 -6.0953 4.14694 +17 2 17.0138 10.497 15.7581 19.6671 8.99174 -7.62884 +18 2 15.6617 11.0456 16.2513 11.6446 -5.87426 0.419849 +19 1 10.7179 14.9528 2.30402 9.26606 5.76352 20.4147 +20 2 10.604 14.349 3.06349 2.85769 5.88214 -5.84145 +21 2 11.1755 15.7297 2.69585 -5.79349 -8.7688 -7.8832 +22 1 17.1683 8.21322 10.7989 1.82063 -1.23871 -1.95171 +23 2 16.5117 8.80699 11.1832 -0.385781 3.51193 7.00123 +24 2 17.9642 8.75858 10.6912 0.976865 0.382705 -5.65698 +25 1 14.6466 15.9322 16.4418 -21.6809 -6.01765 9.50279 +26 2 13.7097 16.2329 16.4085 18.6708 -4.64396 -3.84163 +27 2 14.6751 15.3815 17.2568 4.92661 10.5457 -14.6576 +28 1 12.1005 13.348 0.567693 14.0677 -11.0124 3.49805 +29 2 11.7977 13.4785 18.3054 -3.25303 6.53047 -2.60123 +30 2 11.7369 14.0166 1.16546 -7.92056 -0.136763 -7.41856 +31 1 9.34615 5.48792 3.88275 21.7787 0.248377 2.40385 +32 2 8.84331 5.37966 4.67443 -9.14 -4.08483 27.4632 +33 2 8.65688 5.52523 3.23949 -14.702 1.76912 -26.3373 +34 1 1.6606 4.00652 11.6035 4.04251 -10.384 -6.17332 +35 2 1.67583 4.94617 11.8049 -2.44143 11.0832 5.72027 +36 2 2.2695 3.55993 12.2146 -3.92557 1.72629 -0.38872 +37 1 2.08139 6.85853 8.20375 5.25116 9.81515 7.60897 +38 2 2.56831 7.24635 8.96213 -7.90159 -5.93168 -10.5698 +39 2 2.00199 5.91426 8.39105 -0.650687 0.0621593 5.33933 +40 1 5.36768 4.45674 7.91405 -3.32795 5.87339 3.17518 +41 2 5.46396 3.51228 8.0104 5.66802 -14.4695 -1.12836 +42 2 4.78412 4.56623 7.16078 -4.98903 9.02084 -4.56071 +43 1 3.31193 2.91026 17.4243 5.25503 -22.5991 -0.535021 +44 2 3.97925 3.43469 16.9765 8.2555 0.833912 -8.18173 +45 2 2.82292 3.51814 17.9594 -9.74498 21.4045 11.9966 +46 1 7.44628 5.47686 6.16962 4.83779 4.18627 -38.8589 +47 2 7.80337 6.02378 6.84422 19.7966 19.2933 17.1246 +48 2 7.08839 4.74785 6.63594 -15.5951 -22.4752 14.0992 +49 1 9.79841 6.99298 12.0115 -14.4173 0.175621 -19.7413 +50 2 10.2338 6.25953 11.5352 -7.27244 10.6531 4.67439 +51 2 9.07403 7.33711 11.4082 20.5779 -11.7539 16.8314 +52 1 14.0932 3.73018 8.11294 -2.35225 21.206 2.79521 +53 2 13.7164 4.53948 7.70027 6.06412 -15.1972 7.35067 +54 2 14.2932 3.96864 9.04107 -1.96145 -2.4542 -11.4015 +55 1 4.4865 17.2305 3.91995 2.87421 -17.2964 21.8602 +56 2 5.37817 17.5632 3.85852 13.1015 6.2627 -4.15101 +57 2 4.01126 17.4425 3.12603 -6.70645 13.3364 -16.7923 +58 1 16.3503 16.556 10.4027 -28.8153 -10.9362 -6.11544 +59 2 15.5262 16.5238 10.94 14.5825 4.08322 -8.19499 +60 2 16.0782 16.1167 9.56389 6.69544 5.4961 14.7824 +61 1 2.00781 4.81695 0.19428 -16.7794 -3.94444 -13.379 +62 2 2.36068 5.21925 0.976813 15.1603 4.4174 16.1734 +63 2 1.77343 5.5764 18.2905 0.379182 1.41768 -5.2961 +64 1 11.3582 13.2716 16.3898 -3.93488 16.8957 9.12151 +65 2 10.9039 12.4355 16.5285 -2.10099 -6.82713 -1.65452 +66 2 11.9323 13.1324 15.638 7.04428 -4.38588 -8.74921 +67 1 10.1365 10.938 16.8467 -2.82235 24.3376 4.32555 +68 2 10.5718 10.0987 16.7812 6.05632 -17.4389 0.305733 +69 2 9.20542 10.7786 16.7086 -10.6888 -4.42603 -1.21793 +70 1 11.8139 17.4685 13.4625 16.8497 6.47801 1.45884 +71 2 12.3399 16.8066 12.9857 -2.09189 7.12722 0.625626 +72 2 12.305 18.316 13.3535 -13.8327 -6.90215 0.736174 +73 1 6.44924 9.38958 12.2401 6.69888 0.367183 -15.9058 +74 2 7.02028 9.14259 11.4734 -10.412 6.11649 20.9521 +75 2 7.00474 9.9221 12.8226 3.16796 0.0903621 -0.913647 +76 1 16.2861 12.8631 2.69282 -5.5095 27.1919 6.93721 +77 2 17.1297 13.3403 2.5399 -11.4064 -12.6315 1.20497 +78 2 15.6248 13.5969 2.82884 15.7371 -22.5818 -6.03687 +79 1 0.705842 12.6958 5.89372 11.1118 0.602373 24.8353 +80 2 1.18521 12.4959 5.09265 -4.47491 1.87676 -19.0631 +81 2 18.418 12.5564 5.72922 -11.8137 -1.703 -8.70405 +82 1 5.28198 16.3804 18.4185 -2.246 1.3069 9.83982 +83 2 5.62966 15.5825 18.0261 2.19299 -6.30074 -9.03385 +84 2 5.78103 16.4802 0.590407 -0.738213 6.24336 1.72583 +85 1 0.669378 7.71651 4.13384 -59.2278 -40.1014 26.2385 +86 2 0.0696389 8.03317 3.4616 -5.2936 5.59306 -12.1338 +87 2 1.48105 8.07531 3.93226 66.8664 27.2164 -22.0097 +88 1 3.17848 8.98449 6.48797 -11.6429 31.0556 -28.5774 +89 2 3.69754 8.52221 7.10624 17.5545 -20.4274 28.0681 +90 2 2.28321 9.06095 6.81713 -8.12873 -6.01142 5.66961 +91 1 7.27057 10.3561 16.259 12.8547 -0.986094 -7.05958 +92 2 6.52139 10.8488 15.9387 -6.88577 4.52419 -2.25862 +93 2 7.07809 10.1849 17.1799 -5.89204 -3.21212 7.89434 +94 1 11.0493 0.926342 5.00492 7.6282 -0.312775 10.2028 +95 2 11.2745 1.78939 4.63491 -8.49938 0.0964505 -4.50291 +96 2 10.791 0.378052 4.25157 -0.730025 2.38059 -0.222793 +97 1 4.31171 2.85627 13.1955 -2.92819 26.6809 -11.7177 +98 2 4.37585 3.38692 13.9969 4.42074 -3.40265 4.05123 +99 2 4.21422 1.95476 13.4751 -3.58996 -22.8444 6.9477 +100 1 8.4068 10.257 1.78795 4.04191 -13.9705 -5.37842 +101 2 8.26785 10.8775 2.49552 -4.14797 15.7472 11.4003 +102 2 8.5529 9.42866 2.25521 3.43453 -4.46737 -1.06154 +103 1 10.2803 1.70096 15.4762 8.76071 -4.61575 -1.32446 +104 2 11.1657 1.41822 15.7142 3.10462 2.167 2.36838 +105 2 10.3075 1.82832 14.5156 -8.33356 3.27592 2.91474 +106 1 2.63173 12.8085 7.89063 4.0959 -9.21484 -0.859497 +107 2 3.2295 13.3973 7.41028 -2.49756 4.22571 1.84267 +108 2 1.98308 12.5062 7.24287 -1.99659 4.67741 -0.497136 +109 1 3.82895 11.7184 5.01628 -2.65331 8.28036 11.6201 +110 2 3.66291 11.1157 5.74556 0.426771 -3.98214 -1.1075 +111 2 3.01542 11.7805 4.50368 -0.128738 -0.0731644 -2.81963 +112 1 6.76514 14.4734 16.965 3.61018 3.02569 -11.8589 +113 2 7.44445 15.1431 17.0872 4.2046 -3.50831 2.36163 +114 2 6.5725 14.4959 16.0119 -5.95898 4.08629 6.49151 +115 1 14.2172 14.5156 3.23512 -15.7654 4.80027 20.0484 +116 2 13.9157 15.4376 3.23841 -0.320177 -6.15912 -4.56224 +117 2 13.7912 14.1249 4.0321 9.04818 0.126488 -15.8424 +118 1 8.62194 18.1001 16.0659 -23.21 2.71751 -2.03066 +119 2 9.16623 17.3958 16.3546 8.59431 -35.107 8.94544 +120 2 9.24682 0.159724 16.0687 7.59352 33.2076 -10.3682 +121 1 4.64785 1.66473 4.88429 20.0976 -32.3539 12.8345 +122 2 3.91841 2.23972 4.98678 -27.2909 21.6553 1.42112 +123 2 5.29938 2.12424 4.3745 8.75708 11.4615 -15.3566 +124 1 14.996 12.6195 16.4803 11.4842 8.30008 2.93566 +125 2 14.5677 12.8295 17.3315 -5.03395 -0.949445 -14.8823 +126 2 14.3989 12.5973 15.7101 -8.95177 1.91572 10.2236 +127 1 15.728 18.434 16.8656 -21.8007 21.3443 -35.9839 +128 2 16.2692 18.4514 17.6234 28.2096 -0.560819 33.2727 +129 2 15.2446 17.617 16.9069 0.184765 -20.6285 -2.2654 +130 1 1.36479 1.27889 16.6468 -16.7944 -10.044 -5.49533 +131 2 2.14801 1.79564 16.8219 8.14362 6.44014 2.70449 +132 2 0.693336 1.65446 17.2331 2.17778 -0.49248 0.882874 +133 1 18.205 4.38071 15.9717 -12.5383 1.08179 -4.34425 +134 2 17.9247 3.87865 15.1967 2.33887 0.121173 2.56773 +135 2 0.514445 4.3883 15.9876 8.17504 0.178033 -1.34417 +136 1 12.1632 17.0104 16.1415 17.8243 8.47052 -8.26904 +137 2 11.4339 16.4838 16.4748 -11.8796 -0.396392 0.7857 +138 2 12.1013 17.0682 15.1696 -12.6199 -2.93135 7.53111 +139 1 16.1201 2.6287 18.1864 3.80406 -3.99791 19.9987 +140 2 15.7935 3.50022 18.4009 -8.69312 10.1277 7.25942 +141 2 15.8264 2.47036 17.3057 -5.74882 -3.05042 -27.5508 +142 1 6.63908 13.8237 10.1059 1.54133 -19.2408 -0.896874 +143 2 6.60488 13.4547 10.9999 -2.4531 4.12781 1.41157 +144 2 6.6237 13.027 9.53669 -1.978 12.9815 -0.0933135 +145 1 10.1367 18.5192 2.71126 14.9692 1.08893 5.4249 +146 2 10.5375 0.290475 1.93143 -3.72697 -2.23961 5.76435 +147 2 9.31873 18.1319 2.42821 -14.2623 -5.70844 -7.57952 +148 1 3.05388 17.7183 6.14163 -17.3097 -9.85118 -22.5426 +149 2 2.24205 17.5791 5.58071 14.4512 3.50974 23.581 +150 2 3.73807 17.7208 5.46344 2.0394 5.03095 2.09251 +151 1 12.6118 16.8054 7.95495 4.58219 1.15158 -10.9791 +152 2 11.8555 16.2225 7.90842 -7.26482 -13.9478 -6.78863 +153 2 12.3849 17.4156 8.64585 -0.135632 15.5831 16.1371 +154 1 14.8975 15.2817 8.22586 -10.0433 25.2404 1.15436 +155 2 14.1016 15.8482 8.35876 13.2826 -12.9576 -5.35538 +156 2 15.2902 15.6258 7.39629 -1.79461 -13.1873 12.9757 +157 1 17.8242 18.245 0.290753 35.0262 5.69882 -22.3559 +158 2 18.562 17.7688 18.4584 -26.5201 3.44978 21.3008 +159 2 18.2553 0.461923 0.458274 -15.0979 -6.94564 5.00195 +160 1 0.811942 10.4929 1.40956 8.77271 16.3938 -17.0751 +161 2 0.0922351 9.87336 1.50209 -12.9574 -8.99075 8.33498 +162 2 0.506251 11.1761 0.770938 6.09002 -9.92994 11.4815 +163 1 1.80057 12.2567 3.3157 -0.00821892 -5.58838 -28.0373 +164 2 1.51905 11.5718 2.65287 2.57103 10.7079 19.8708 +165 2 2.13035 12.9839 2.7472 -5.7627 -4.92842 11.1942 +166 1 0.668516 17.2609 4.94683 -35.85 3.98858 25.1078 +167 2 0.0697466 18.0029 5.19004 17.5579 -5.46754 -17.9658 +168 2 0.309089 16.5456 5.51301 20.6369 3.3795 -13.3957 +169 1 1.1258 0.902495 9.33726 -12.4564 -3.06084 39.8122 +170 2 1.2842 0.722879 10.3134 -2.51149 4.27857 -26.5162 +171 2 0.280567 0.461704 9.18062 1.78742 1.97705 -4.09399 +172 1 16.751 2.38387 13.3212 3.93571 18.018 2.1702 +173 2 16.8889 2.64612 12.3995 3.13812 2.89192 3.07637 +174 2 16.5572 1.45381 13.2916 -4.67688 -18.3777 2.25645 +175 1 2.721 15.8932 12.0356 -10.4038 6.64935 25.1991 +176 2 2.99704 15.5189 12.8835 -2.56405 3.43208 -4.36032 +177 2 3.3254 15.553 11.3859 5.26998 -2.53603 -11.8474 +178 1 16.4132 15.6174 6.13158 -30.6236 -31.2218 7.18947 +179 2 17.2889 15.5331 6.46785 25.936 1.45578 4.51193 +180 2 16.388 16.3213 5.51027 2.55474 24.6255 -21.834 +181 1 5.75165 5.17156 11.8076 -10.0158 20.8309 8.83951 +182 2 5.58328 6.03799 12.2608 0.394348 -20.1746 -10.5178 +183 2 4.95414 4.6515 11.9927 8.5068 -2.87995 -2.26002 +184 1 15.1308 4.87532 0.804768 27.2949 -1.75024 -19.8676 +185 2 14.8777 4.72649 1.70618 -7.53991 -8.08598 20.9925 +186 2 14.4372 5.36761 0.397065 -18.333 11.5318 -5.57633 +187 1 16.3608 16.424 1.96087 0.545069 28.5814 -7.81874 +188 2 15.9402 16.8572 2.72963 9.40909 -7.94755 -2.88814 +189 2 16.7928 17.1706 1.4719 -7.75465 -17.4072 6.82817 +190 1 0.195497 4.8427 3.9016 -20.8114 -16.3238 -7.36148 +191 2 0.347935 5.77048 3.88737 2.90582 31.823 0.953261 +192 2 1.01225 4.48793 4.21241 18.9183 -15.2676 9.08502 +193 1 2.99687 15.0761 15.1729 -7.80035 25.004 -19.9303 +194 2 2.75027 14.6107 15.9518 -1.28992 -16.7566 29.7079 +195 2 2.55205 15.9391 15.3182 6.19364 -5.6546 -9.94962 +196 1 1.13925 14.6508 9.53021 19.9076 23.5081 3.98588 +197 2 2.07639 14.8825 9.77663 -29.323 -13.131 -7.88186 +198 2 1.04812 13.6993 9.55892 5.54263 -6.82879 4.76298 +199 1 13.5171 16.5199 11.5195 20.4201 8.76324 22.1576 +200 2 12.9867 17.257 11.2155 -0.855064 7.64635 -14.0191 +201 2 13.0442 15.7467 11.2378 -7.08331 -12.4379 -10.7884 +202 1 4.66723 1.48136 0.73322 23.0149 3.26353 10.1864 +203 2 3.99044 1.945 0.247475 -7.51763 5.99594 -9.81004 +204 2 4.21698 0.879204 1.33273 -6.6714 -6.19828 -5.18082 +205 1 1.48126 18.5865 11.8932 5.77456 11.9109 13.6761 +206 2 1.45047 0.509997 12.7065 -0.655319 -12.4833 -18.3988 +207 2 2.16842 17.9125 12.0331 -8.54366 2.69761 2.01722 +208 1 11.4638 10.1444 4.04596 -29.9846 -9.43843 22.7531 +209 2 11.586 10.5695 3.21678 -1.49335 12.1472 -28.3165 +210 2 12.3366 9.99459 4.35585 30.6386 -4.62302 8.08877 +211 1 8.15809 12.1698 3.75544 16.5318 -12.8496 -25.3624 +212 2 9.0168 12.5594 3.97136 -0.0903232 2.9732 11.2136 +213 2 7.55758 12.2779 4.48666 -4.55936 7.15494 21.2951 +214 1 14.57 4.03338 3.33424 -15.9396 -3.34089 -13.9779 +215 2 15.2475 4.30951 3.93522 14.2067 0.133456 17.245 +216 2 13.7488 4.35662 3.71839 -4.37522 2.77806 -1.52286 +217 1 5.69573 1.64484 7.55416 47.4861 32.5669 -28.9041 +218 2 5.02314 1.22164 8.01158 -49.1519 -34.4826 29.3881 +219 2 5.51675 1.48645 6.61188 -4.44278 2.0561 3.75596 +220 1 17.8757 1.08291 4.8338 -2.11434 0.172647 4.71576 +221 2 18.4455 1.46692 4.16357 3.67184 -2.89676 -9.33974 +222 2 18.0165 1.6381 5.60499 -0.396504 -0.0112538 6.48923 +223 1 6.85338 9.35555 4.52322 8.01303 -7.73923 12.5712 +224 2 6.71294 9.49068 5.48294 3.02765 -1.76203 -13.5451 +225 2 7.79052 9.06961 4.44068 -13.079 3.18293 -1.46589 +226 1 2.62197 14.8521 2.02937 -10.5221 3.39156 -23.0918 +227 2 3.43005 14.7674 2.51892 12.1264 -2.78802 16.39 +228 2 2.89555 15.1253 1.13827 -2.73698 -5.91865 10.4405 +229 1 17.3299 12.9421 13.1931 -12.7738 17.025 -7.03447 +230 2 16.4383 13.2606 13.4479 14.3464 -2.45707 -5.73497 +231 2 17.7945 13.7546 12.8897 -6.22536 -14.4165 5.27249 +232 1 14.8979 10.5619 1.48982 -11.9525 28.8063 14.5441 +233 2 15.3485 11.4081 1.81139 -13.0513 -30.8314 -8.90843 +234 2 13.9324 10.6539 1.67123 25.3412 1.8999 -4.23485 +235 1 5.67595 6.67872 4.55433 0.362155 18.5292 -10.9955 +236 2 5.7867 7.61135 4.29326 0.453279 -5.37291 7.09585 +237 2 6.40948 6.48302 5.14674 -0.086512 -6.41659 5.49044 +238 1 7.99316 8.32936 10.3099 -9.88556 -13.348 -36.673 +239 2 8.52429 8.77949 9.6279 3.30308 5.35046 16.0689 +240 2 7.32365 7.86355 9.75728 7.50693 2.48224 14.219 +241 1 13.4328 18.4778 5.70681 16.0844 -0.193399 -6.38488 +242 2 12.6986 0.421386 5.55211 -13.5651 7.65576 -7.58054 +243 2 13.084 17.8957 6.37412 -0.0453673 -15.2248 15.7361 +244 1 -0.0111344 2.60704 0.305045 25.2129 -30.2702 8.72131 +245 2 17.7164 2.72495 0.164021 -32.2143 -6.6311 -9.93678 +246 2 0.303096 3.48034 0.225751 24.1306 33.5707 -2.06333 +247 1 12.8325 10.9421 9.75806 8.08682 -36.6012 3.93532 +248 2 11.88 10.8422 9.79419 -10.8426 11.3849 -4.95145 +249 2 13.0795 10.0004 9.94273 0.259667 22.5692 -5.0531 +250 1 0.642026 12.1683 11.0609 4.45464 6.09796 -5.6804 +251 2 18.3356 12.2213 11.2584 6.06715 1.14224 4.76964 +252 2 1.15053 12.4132 11.8471 -8.72956 3.82018 2.8882 +253 1 5.19121 7.35128 13.362 14.2217 -1.26987 2.88721 +254 2 5.71731 8.09811 12.9969 -6.96977 -10.5111 6.72344 +255 2 5.67215 7.04852 14.1611 -4.50302 8.90065 -9.08298 +256 1 1.17753 6.82665 11.884 -6.96202 23.1207 3.27017 +257 2 0.332868 7.13942 11.4836 19.3553 -6.8941 9.30012 +258 2 1.59694 7.61812 12.3119 -7.65201 -17.5731 -13.8958 +259 1 15.4801 9.74186 12.3501 8.02403 -36.537 -7.5848 +260 2 15.2771 10.6331 12.1319 -8.61126 25.0623 0.312061 +261 2 15.6595 9.70704 13.2832 1.37326 2.5629 11.9963 +262 1 16.5169 12.594 5.50965 10.4637 -15.548 10.5874 +263 2 16.3074 13.4879 5.77305 -4.76715 16.3332 -4.64473 +264 2 16.4013 12.5274 4.55501 -3.26126 3.70708 -8.86796 +265 1 6.31292 9.82321 0.0853393 -0.254663 19.8779 15.0366 +266 2 5.47299 10.2624 0.316114 7.63969 -1.93852 0.671735 +267 2 6.95815 10.0698 0.784254 -6.58085 -1.04763 -9.09577 +268 1 12.2316 6.09819 4.0135 -11.5327 11.7492 -3.18772 +269 2 12.1819 6.93481 3.49894 6.0574 -18.2652 4.97925 +270 2 11.3139 5.7855 4.02535 4.75129 -2.10791 -0.415098 +271 1 0.346102 12.8439 0.0895734 -4.86896 0.353582 5.39062 +272 2 18.7507 13.4631 0.799834 -0.48412 -1.67542 -1.66039 +273 2 18.3682 13.0274 18.0218 -2.69393 2.08889 -5.2677 +274 1 3.5489 0.022651 8.64264 14.8213 -2.21723 6.15117 +275 2 3.34146 18.2537 7.79412 -1.37888 1.54429 -1.85278 +276 2 2.69807 0.312924 8.99074 2.91061 0.134312 -8.36673 +277 1 7.48275 17.4677 4.49597 -9.82961 -11.4008 2.47905 +278 2 7.76172 18.3639 4.65831 -0.473756 11.2371 0.709742 +279 2 7.61951 17.3416 3.55584 -1.72206 -2.44101 -5.98946 +280 1 9.27482 17.1419 12.2002 -29.9673 17.8198 -3.75997 +281 2 9.29449 16.2474 11.8858 2.76409 -17.0257 -9.00951 +282 2 9.96887 17.232 12.8306 24.004 1.27191 14.3563 +283 1 13.3881 13.0638 7.94543 23.8544 1.05207 16.0454 +284 2 13.4911 12.3591 8.61055 -7.80977 1.42534 -8.25381 +285 2 14.1677 13.6583 8.10929 -22.3675 -6.64423 -7.05202 +286 1 14.8196 2.98416 15.4059 10.9247 4.82989 11.3692 +287 2 14.1977 2.30622 15.182 -14.8004 -11.8419 -2.86461 +288 2 15.3715 3.04555 14.6288 11.3419 0.403673 -8.50968 +289 1 9.89007 15.644 16.9507 -0.476448 -13.1737 2.9886 +290 2 10.2689 14.811 16.6236 0.33136 1.14394 -2.50282 +291 2 9.50974 15.3862 17.8064 -0.51987 6.75584 -0.702029 +292 1 11.2404 8.49746 16.6126 -11.0388 -24.1902 -5.6141 +293 2 10.5493 7.95233 16.1656 11.7734 11.5748 6.95591 +294 2 11.5411 7.95338 17.3605 -0.459906 4.27214 -6.12679 +295 1 3.94653 18.1828 16.8275 -12.5536 19.575 -10.0724 +296 2 4.49583 17.6028 17.3635 4.26127 2.6886 8.36922 +297 2 3.95977 0.456308 17.1729 5.72776 -19.9128 0.46306 +298 1 2.2132 4.22212 8.91052 -3.52394 3.62108 -17.0138 +299 2 3.14576 4.09878 8.74947 8.67559 -2.34434 0.767855 +300 2 2.06536 4.03466 9.83165 -0.817379 -1.75645 17.2153 +301 1 9.87247 10.3712 9.74928 14.7683 -30.296 -5.49075 +302 2 9.62147 11.2221 9.45607 -13.6864 32.2476 -14.4563 +303 2 9.99394 10.4206 10.6874 0.365841 -1.43755 21.5864 +304 1 9.68376 0.92477 10.8522 -9.86416 -7.8375 -9.37303 +305 2 9.18791 0.169256 11.2055 11.1043 -0.796798 3.35444 +306 2 9.09399 1.23638 10.1435 10.2069 6.90097 4.69651 +307 1 9.16769 15.091 10.1956 22.4355 7.87639 6.21774 +308 2 8.9696 15.9691 9.88131 -3.17938 11.9605 -8.33522 +309 2 8.32743 14.6622 10.1389 -19.5916 -16.662 -1.08184 +310 1 0.85922 9.69743 10.2442 32.6336 -47.5631 -25.4673 +311 2 1.02374 10.6105 10.3992 -2.53948 25.7241 9.50189 +312 2 1.72313 9.35148 9.87448 -35.4256 9.68482 16.6576 +313 1 17.0256 4.81986 8.08308 31.6348 -31.2729 -9.48192 +314 2 16.3215 5.37214 8.33224 -31.3655 27.4802 10.3117 +315 2 16.9319 4.0155 8.6004 0.768816 2.34372 -1.45333 +316 1 14.8081 14.6794 0.153243 -2.85725 -11.5952 -11.9613 +317 2 15.2092 15.2804 0.771003 11.383 9.73034 15.7651 +318 2 14.0408 14.3115 0.591288 -7.92269 -3.99881 6.06231 +319 1 3.80416 11.0019 9.56526 0.623941 6.68377 2.11405 +320 2 3.77619 11.4642 10.4186 -0.043788 -6.16761 3.62327 +321 2 3.31763 11.5705 8.95624 -4.54045 6.84371 -3.4313 +322 1 11.3158 10.7476 1.45776 10.9951 -9.43983 2.74041 +323 2 11.5252 11.5694 1.01773 6.8042 14.5185 -3.76913 +324 2 10.3718 10.6573 1.35733 -14.9091 -3.38451 -2.45366 +325 1 13.1832 7.19978 12.6897 5.92706 -14.8401 5.32281 +326 2 14.1145 6.87754 12.7085 -13.0936 9.37511 -3.26372 +327 2 12.6462 6.38983 12.7968 5.91866 7.22274 -2.53959 +328 1 9.61767 1.88189 0.936979 -6.6056 8.12678 -33.3335 +329 2 8.75647 1.76915 0.468433 15.5153 -2.73343 13.4493 +330 2 10.2273 2.17983 0.230861 -6.38326 -0.489196 14.1696 +331 1 10.6523 13.47 4.56634 -17.7163 6.61907 -5.84307 +332 2 11.5562 13.1849 4.68206 11.5009 -9.86279 4.07703 +333 2 10.5151 14.0877 5.29021 -1.44258 0.681598 7.9468 +334 1 14.5213 1.69385 10.9785 0.412416 12.5139 1.3055 +335 2 15.3159 1.33414 10.5754 1.96072 -4.24727 -0.900333 +336 2 14.7412 2.63918 11.0728 -6.13642 -3.41388 -3.76294 +337 1 14.5042 12.0777 11.6111 -12.2061 0.510996 31.5423 +338 2 15.1827 12.4648 11.0978 29.2487 15.6657 -21.0239 +339 2 13.909 11.6953 10.9807 -16.843 -4.29027 -12.6849 +340 1 8.18401 5.11068 9.87002 -0.676892 -7.65738 -3.35075 +341 2 7.33939 5.06675 10.3357 0.521056 4.21206 1.1001 +342 2 8.29842 4.21721 9.50312 -0.00697362 5.6522 3.71152 +343 1 1.5768 16.9623 18.4443 13.7844 -6.06932 -11.1938 +344 2 2.08688 17.3314 17.6994 -1.29344 -1.55823 6.9248 +345 2 1.72478 16.0021 18.3853 -4.19272 5.84443 -4.03385 +346 1 1.47359 17.3466 15.3156 -41.3862 18.9515 21.4522 +347 2 1.38751 18.1942 15.8376 11.356 -22.4463 -17.1221 +348 2 0.531998 17.0202 15.2731 27.9598 4.08453 -2.72162 +349 1 3.56251 5.80266 6.06315 1.23781 -30.1986 0.952301 +350 2 2.9922 6.42371 6.50913 -3.22231 11.6367 6.59476 +351 2 4.22501 6.28135 5.5614 1.05528 7.23928 -6.44245 +352 1 12.5723 9.4951 14.2463 -14.1947 49.7353 4.36555 +353 2 12.9086 8.77822 13.7576 17.8642 -40.1771 -16.3075 +354 2 12.2963 9.16979 15.1004 -1.36164 -11.5003 11.0357 +355 1 4.07044 15.2648 6.99086 -8.22484 -15.5272 10.3185 +356 2 3.65725 16.0904 6.74002 -9.77102 8.77549 -2.61135 +357 2 5.00026 15.4315 6.88928 20.0063 2.47059 -3.54324 +358 1 0.744606 8.73408 15.0763 0.0218964 -5.95646 -3.10884 +359 2 0.519262 9.66197 15.1074 -7.84082 12.7234 2.89932 +360 2 1.47025 8.73132 14.4431 5.87969 -4.51966 -2.6491 +361 1 12.9306 8.27919 10.1905 8.08936 2.40022 19.7343 +362 2 13.779 7.90886 9.87037 -9.22858 -4.32337 9.26771 +363 2 12.8604 8.07471 11.1624 7.69549 -2.50096 -25.1681 +364 1 15.3235 7.85492 3.5497 18.4153 32.411 -54.1913 +365 2 14.4745 7.6657 3.15314 -16.0822 -13.4855 9.94503 +366 2 15.5116 7.64082 4.44166 -12.2255 -21.7424 34.152 +367 1 17.2256 6.71185 18.6385 13.0601 3.46678 -1.24204 +368 2 16.7837 5.9846 0.423329 -10.4159 -11.046 2.92977 +369 2 16.5307 7.32814 18.3852 -6.78357 2.8142 -3.2779 +370 1 8.8964 6.96848 7.83902 16.0931 16.0227 -2.80611 +371 2 9.83265 7.28699 7.8278 -17.1093 -4.77101 0.707558 +372 2 8.79691 6.46408 8.64714 -0.939429 -8.3316 9.69843 +373 1 12.4084 0.523138 1.23768 -2.06115 0.0733923 -7.11266 +374 2 13.1872 0.998726 1.54472 7.23891 -2.91784 -1.02165 +375 2 12.4662 0.537618 0.274809 1.69654 -3.93261 2.5223 +376 1 5.65468 15.0902 14.5334 3.02676 -25.5773 -0.125585 +377 2 4.72407 15.1616 14.7961 0.127409 2.72757 -0.91443 +378 2 5.99013 15.9712 14.3886 3.52657 16.2654 -6.40367 +379 1 3.82399 6.39797 1.75512 3.78691 -6.14258 3.26006 +380 2 3.37829 7.15763 1.38654 -6.41374 16.3556 -5.84968 +381 2 3.97609 6.61981 2.67876 -1.82166 -0.0414506 2.69272 +382 1 3.91801 11.4637 12.3808 6.26728 1.11409 -8.60855 +383 2 4.78798 11.8777 12.4982 -7.30712 -3.21292 -1.54071 +384 2 3.30212 12.087 12.775 -5.64928 0.778082 5.20377 +385 1 5.29676 3.85177 15.8189 3.43828 -31.27 -8.27082 +386 2 6.03967 3.23378 15.6029 -11.8461 12.1043 0.727598 +387 2 5.68429 4.70341 15.931 13.0054 23.274 1.41344 +388 1 14.2193 10.1559 4.56622 -21.9238 17.9967 10.7876 +389 2 14.2923 9.81422 5.45847 5.67938 -3.41822 10.3914 +390 2 14.6614 9.51741 4.03067 14.2685 -12.4061 -15.9356 +391 1 7.6994 17.3598 9.13069 2.58566 -7.07749 -1.38218 +392 2 6.9688 17.7373 9.6086 -11.208 -1.02501 12.7072 +393 2 7.91331 18.0249 8.47917 9.78731 5.09099 -13.1281 +394 1 4.50671 14.5226 3.97805 12.528 -25.4608 -46.8355 +395 2 4.48015 15.4086 4.24602 -0.161492 47.21 12.2969 +396 2 4.35306 14.022 4.74858 -6.07017 -24.5156 30.0525 +397 1 14.1411 7.46132 15.8217 -22.5264 -9.25347 -2.17647 +398 2 14.9826 7.35759 15.4044 20.5288 -0.540355 -7.58788 +399 2 14.3421 7.83921 16.6731 3.72262 6.08742 11.7763 +400 1 2.98184 18.372 1.90579 -20.1648 -30.237 -17.2141 +401 2 2.43548 17.7555 1.32026 19.5303 24.385 16.7936 +402 2 2.33791 0.236975 2.41065 -5.95562 0.980031 -0.0237849 +403 1 7.99445 1.58502 4.53075 18.7977 0.504684 -14.6733 +404 2 7.48712 1.99417 3.8192 -9.17378 0.780153 1.87786 +405 2 8.88078 1.50473 4.13387 -7.12077 1.17171 10.2984 +406 1 2.41951 14.1599 17.7056 22.0207 15.2121 -4.13121 +407 2 1.68443 13.6195 17.9516 -15.3327 -12.8663 8.26013 +408 2 3.18525 13.6986 18.0793 5.57496 -0.0710026 -2.65101 +409 1 0.908587 1.85846 13.8858 -0.0793858 -1.94323 14.6669 +410 2 1.14821 1.59902 14.7928 -3.46921 3.66635 -7.67361 +411 2 18.5942 2.00299 13.9058 4.01903 -0.250224 -6.72878 +412 1 4.32702 0.129386 13.8829 -0.0770511 3.08332 3.55447 +413 2 5.24833 18.5067 13.8286 4.90059 -4.64875 -2.30826 +414 2 4.05486 18.5232 14.7746 -2.81766 -1.27361 1.32354 +415 1 7.27357 0.854459 18.3804 -15.3869 4.3045 -1.1218 +416 2 7.16992 0.518993 17.4624 3.36336 5.55626 15.3605 +417 2 6.40185 1.20099 18.6914 11.5657 -10.6186 -10.5297 +418 1 15.9542 18.4046 13.9208 -25.3022 5.029 -14.7602 +419 2 15.0075 18.5254 13.735 13.8644 -2.42428 -4.09563 +420 2 16.0061 18.5076 14.8614 8.67486 -1.51607 21.0166 +421 1 10.2392 4.55204 16.2801 10.7238 -8.25817 -3.6178 +422 2 11.196 4.37813 16.4864 -24.802 4.89259 -9.76699 +423 2 9.86858 3.73489 15.891 10.2726 5.88423 10.0044 +424 1 15.9238 17.7149 4.45644 2.75189 -23.1215 -12.8271 +425 2 16.5168 18.4535 4.47728 14.6813 18.6917 2.39924 +426 2 15.0936 18.0469 4.76398 -21.0845 8.87368 10.3462 +427 1 6.95648 17.503 13.9077 -51.9825 -4.38955 -3.71365 +428 2 7.39002 17.773 14.6913 25.8751 9.72049 29.5532 +429 2 7.60747 17.4983 13.2335 27.2317 -2.92469 -23.3456 +430 1 13.2071 6.48879 6.54043 12.3601 -8.29587 -18.0485 +431 2 14.1818 6.5258 6.42811 -17.7974 6.95191 3.55269 +432 2 12.8555 6.35956 5.62691 5.37067 1.68412 18.5111 +433 1 7.86742 2.30794 9.39626 -5.35093 5.07188 8.74379 +434 2 7.30782 2.2926 10.1983 5.67726 -4.12754 -5.74363 +435 2 7.33716 1.92062 8.69482 -5.03183 0.0809058 -6.36949 +436 1 15.2078 14.7586 13.7432 0.832397 -4.30074 -2.87903 +437 2 14.8858 14.9257 14.6258 -3.94452 3.16733 11.6107 +438 2 14.9517 15.5204 13.2236 -2.78606 2.09491 -5.66724 +439 1 9.4202 8.34719 3.8485 -22.8652 4.71801 -4.87246 +440 2 10.1988 8.89706 3.87201 15.3465 4.97444 3.28263 +441 2 9.69606 7.44575 4.01411 1.53448 -7.03017 -1.02937 +442 1 17.7384 13.5884 16.4052 -11.7067 -11.536 8.32036 +443 2 16.7673 13.5542 16.377 3.38001 -6.87595 1.27552 +444 2 17.9496 14.385 15.9274 3.88108 14.0768 -7.71607 +445 1 4.90559 10.5521 2.87839 21.3367 -20.8737 -11.4011 +446 2 5.623 10.1254 3.38432 -4.07258 6.62764 -8.01418 +447 2 4.62886 11.2624 3.4373 -4.18877 12.0113 9.86562 +448 1 3.72998 8.3995 9.96949 0.206562 0.552242 5.18998 +449 2 3.80623 9.33185 9.71276 -0.050758 -4.34606 1.0469 +450 2 3.86748 8.41721 10.9275 -4.36654 -3.13592 -2.04235 +451 1 15.965 6.95365 5.95266 -6.26742 1.66997 1.55481 +452 2 16.7698 7.37181 6.25298 11.0034 6.69643 7.83926 +453 2 16.2161 6.06091 5.70554 3.02292 -8.38979 0.185448 +454 1 15.1879 7.19538 9.00463 -16.574 -33.0638 16.9279 +455 2 15.9728 7.55664 9.38717 21.7076 13.0833 8.35481 +456 2 14.9649 7.65827 8.21955 0.87619 20.3483 -26.3308 +457 1 6.20656 12.8742 12.7233 -2.45823 6.18764 -5.3718 +458 2 6.79799 12.2543 13.1384 18.4055 -9.75357 3.10315 +459 2 6.13621 13.6122 13.3363 -4.91508 8.57981 5.63651 +460 1 12.128 4.53555 13.1062 -17.5662 -8.78193 22.9206 +461 2 12.3906 4.63486 14.0411 2.44404 0.930561 -9.75427 +462 2 11.3004 4.01263 13.1714 14.0583 8.15169 -11.9376 +463 1 11.4184 8.10098 7.95437 7.14359 -3.91624 -16.2991 +464 2 12.1028 7.60478 7.4673 -7.16754 1.39876 -0.578178 +465 2 11.8093 8.18067 8.82553 -2.79742 2.89488 8.77133 +466 1 17.0514 10.8651 7.58728 -24.1088 0.784299 26.3012 +467 2 17.8144 10.3384 7.41217 20.5663 -15.9736 -11.9321 +468 2 16.8601 11.4269 6.84052 2.19633 6.48519 -17.1676 +469 1 5.231 18.0993 10.8546 26.455 4.8965 -4.82813 +470 2 4.8195 17.6908 11.6007 -11.7048 -9.88744 14.1218 +471 2 4.63699 18.0004 10.1206 -18.4061 3.17503 -16.8763 +472 1 7.59767 17.4436 1.69759 5.72815 6.19172 -16.2775 +473 2 7.89477 16.6568 1.18579 0.971667 15.0969 7.35096 +474 2 7.65141 18.2352 1.10536 -4.88626 -20.2664 5.47735 +475 1 1.93145 12.9234 13.6206 5.60545 -3.12143 -21.3855 +476 2 1.4749 12.3281 14.2061 -8.56587 -7.9862 10.2726 +477 2 2.17547 13.6903 14.1341 4.19375 11.0678 7.71152 +478 1 9.43748 6.79443 14.8327 33.0335 -30.4644 -7.71462 +479 2 9.91196 6.01751 15.25 -19.5648 18.6507 -3.60269 +480 2 9.7502 6.76156 13.9011 -9.65438 10.9618 10.9707 +481 1 15.2831 4.34212 10.7772 21.179 15.7439 -2.01388 +482 2 16.2293 4.27243 10.5111 -19.8675 -5.23 11.4528 +483 2 15.2971 5.09975 11.4021 -5.00612 -14.3562 -6.14057 +484 1 11.351 6.2072 0.109577 23.6613 28.7979 6.66193 +485 2 11.4872 5.27024 0.0694097 -6.21323 -21.6319 -6.22108 +486 2 10.4676 6.44004 18.4761 -18.3883 -9.25121 -2.88973 +487 1 18.5357 11.4228 14.9398 26.7643 -26.8403 31.1109 +488 2 18.0597 11.723 14.1947 -18.2778 17.0129 -29.9513 +489 2 18.4532 12.1424 15.5699 -5.23995 5.81903 4.32114 +490 1 7.05668 9.28071 7.31234 -6.58466 7.4517 -4.55549 +491 2 6.71011 8.47084 7.6978 -4.31789 -6.13087 1.68327 +492 2 7.98804 9.13135 7.18438 15.6823 -2.37616 0.276954 +493 1 18.324 15.3331 12.2569 -7.46978 -1.64803 5.36971 +494 2 0.564477 15.5946 11.9899 10.9599 1.36641 -5.51497 +495 2 17.7284 15.6281 11.5548 0.957946 6.58656 -2.69515 +496 1 16.4958 4.38611 5.25998 2.69003 14.057 -30.634 +497 2 16.6253 3.88668 6.0538 7.32023 -9.57738 16.711 +498 2 17.3371 4.41488 4.75201 -4.14044 -1.60108 11.4247 +499 1 17.7073 3.15256 10.779 -3.63642 -2.40486 -9.15002 +500 2 18.6235 3.40441 10.9111 8.43018 2.88916 7.88185 +501 2 17.7389 2.35032 10.2471 -2.89329 -5.91517 0.580451 +502 1 12.2813 18.6401 10.1181 2.89516 -35.5496 -8.35074 +503 2 11.4703 0.383955 10.4005 -29.8535 10.9583 6.97968 +504 2 12.9196 0.674429 10.2218 25.4798 25.6209 2.989 +505 1 10.3974 9.74216 12.5073 0.112101 -17.0368 -3.21727 +506 2 11.1947 9.82557 13.039 4.39701 4.68697 5.66162 +507 2 10.3035 8.76836 12.4158 -2.37231 15.8308 -1.56525 +508 1 0.663588 2.73535 7.12598 -12.3374 1.53361 -6.62113 +509 2 0.367817 3.62684 7.37457 5.09588 -7.68469 3.80292 +510 2 0.956045 2.28157 7.92852 1.53616 1.67998 2.79736 +511 1 0.311147 15.2759 6.88171 -13.4592 45.4783 4.03261 +512 2 0.500617 15.614 7.76495 4.81164 -9.60864 4.06796 +513 2 0.558697 14.3764 6.88071 13.8097 -37.6199 -4.57419 +514 1 17.0548 6.97395 15.0744 4.20776 -1.94343 -1.58424 +515 2 17.8177 7.57453 14.9855 -5.12063 -2.20736 -0.0554095 +516 2 17.4111 6.17613 15.4934 -0.113823 0.922547 0.618491 +517 1 9.1503 12.5213 8.01319 -14.1189 2.82879 0.278945 +518 2 9.53356 11.9725 7.3299 10.3093 -11.5802 -1.96405 +519 2 8.24075 12.6139 7.71394 -0.988228 2.45183 6.21614 +520 1 1.17609 1.70844 2.83295 3.23913 -2.31621 -1.89882 +521 2 1.09855 2.22978 2.02752 -9.74566 -1.77621 -3.35395 +522 2 1.86202 2.13223 3.34238 5.26299 8.17365 10.1548 +523 1 4.09291 15.1504 9.8922 18.1507 -7.2721 -6.40054 +524 2 4.03036 15.1629 8.92399 -1.00826 2.87435 -0.463193 +525 2 4.99389 14.8146 10.0732 -8.74469 0.915467 -5.31212 +526 1 7.37772 2.25117 14.7222 3.22505 8.21162 1.39777 +527 2 7.09502 1.54536 14.1374 1.57311 -0.181539 -4.41158 +528 2 7.85635 2.90205 14.1691 -14.4419 -9.06063 9.37489 +529 1 18.4006 14.5833 2.15968 -9.78242 8.50711 -1.4388 +530 2 0.62994 14.8842 2.46282 -4.8788 5.17113 -0.292034 +531 2 17.7517 15.3351 2.17575 17.725 -12.6913 0.414249 +532 1 9.99197 2.68277 12.9223 -2.58103 11.7713 -8.17336 +533 2 9.96789 2.1685 12.101 0.346485 -5.49174 3.23624 +534 2 9.29748 3.35451 12.7936 3.47695 -5.23648 4.96996 +535 1 2.96299 8.91941 13.096 19.2939 -0.203164 0.561242 +536 2 3.4486 9.7527 12.8428 -15.067 -18.0348 7.07188 +537 2 3.65865 8.27445 13.3679 -12.9331 14.6867 -6.35999 +538 1 3.26147 8.578 3.77304 6.38222 5.3653 -9.36202 +539 2 3.78874 9.26676 3.32736 -9.65467 -7.00498 -1.39723 +540 2 3.24393 8.8647 4.68594 3.08129 -4.64857 6.90262 +541 1 5.77287 7.24333 8.61048 -1.78661 -5.00814 9.07462 +542 2 5.68022 6.28289 8.53661 4.0016 -1.85755 -4.86386 +543 2 5.00276 7.50215 9.14094 4.61323 4.45406 -2.92895 +544 1 14.8793 1.52937 1.85035 -12.7334 -14.0835 12.9397 +545 2 14.819 2.16152 2.5876 10.8144 6.55959 -13.4181 +546 2 15.5594 1.73936 1.19754 -2.84827 11.2594 2.6977 +547 1 8.5607 15.0611 0.725284 0.46926 -2.1008 2.83341 +548 2 9.29259 14.9147 1.35885 -7.99161 6.01774 -7.32206 +549 2 7.81927 14.5289 1.05772 1.7687 -2.35649 0.826934 +550 1 15.4921 1.3993 7.20702 14.746 2.01238 2.95597 +551 2 14.8484 0.891915 6.72418 -10.4472 -9.96976 -7.88743 +552 2 15.1077 2.27361 7.28199 -8.00989 7.94424 8.07076 +553 1 5.01058 12.9585 18.4386 -15.8567 -4.4202 8.08993 +554 2 5.4193 13.0053 0.667327 2.46468 -0.195888 1.58163 +555 2 5.59523 13.4446 17.8643 8.60291 1.11734 -4.66644 +556 1 15.4019 8.61725 18.0949 -10.0539 -8.80276 13.7753 +557 2 15.8344 9.23888 17.5182 6.53635 7.63687 -15.5634 +558 2 15.1418 9.16559 0.203922 1.58583 0.47418 3.18719 +559 1 12.0525 3.11208 18.2861 7.73999 -14.4321 9.61497 +560 2 12.4007 2.82569 0.495607 -5.57788 10.1171 1.38067 +561 2 12.4066 2.43321 17.7002 -1.56388 4.26076 -9.69121 +562 1 13.1688 12.6857 5.1494 7.31226 -7.20074 3.10637 +563 2 13.4985 11.8462 4.78426 1.65488 6.62932 1.41885 +564 2 13.3525 12.6203 6.1046 -3.90991 6.43934 -4.24709 +565 1 6.08926 7.21668 0.130178 -1.88627 11.2856 16.2629 +566 2 6.12641 8.19603 18.8427 -2.9512 -23.7133 -6.32338 +567 2 5.32645 6.95656 0.679872 3.54107 -2.60359 -10.7249 +568 1 17.6547 15.8703 14.9132 16.2429 2.82715 17.6162 +569 2 16.6953 15.9075 15.0555 4.78919 3.7515 -14.6122 +570 2 17.9345 15.7768 13.9856 -18.469 -1.14955 -2.42085 +571 1 13.1468 0.885591 16.7291 -10.7864 15.024 2.10847 +572 2 14.1008 0.813897 16.7431 10.5998 -4.62802 3.60151 +573 2 12.8375 18.6536 16.4909 -4.88764 -9.34618 2.57866 +574 1 10.8908 14.4992 7.43136 -2.2343 -7.03539 12.0134 +575 2 10.0835 14.2065 7.92308 22.5278 2.1252 -13.3834 +576 2 11.6003 13.8396 7.60224 -11.7269 11.3777 -3.99947 +577 1 17.6181 8.42363 2.12766 -11.9935 -3.6797 -6.77545 +578 2 16.7343 8.37762 2.55285 14.0369 1.72981 -7.6286 +579 2 17.5632 7.81953 1.35766 3.76606 6.32419 13.0143 +580 1 12.3929 7.83138 2.01819 4.71096 17.5308 0.40727 +581 2 12.1717 8.7272 1.7221 -1.13772 -2.1217 4.67191 +582 2 11.9464 7.25327 1.39471 0.282935 -6.68024 -6.10503 +583 1 12.0275 14.6478 10.4009 38.9809 -24.2439 -10.9711 +584 2 12.337 14.044 9.6932 -4.28518 13.1756 12.472 +585 2 11.1105 14.7441 10.2592 -43.0899 4.37787 -4.57767 +586 1 6.8265 6.93238 15.5327 -27.6581 -7.97269 5.64053 +587 2 7.73103 7.08984 15.3178 26.4357 1.09681 -7.32033 +588 2 6.59533 7.63547 16.1384 -2.46814 3.13878 5.80205 +589 1 7.96021 4.51991 13.281 5.98272 36.635 4.98876 +590 2 7.18773 4.72006 12.7149 7.22552 -5.34662 5.9239 +591 2 8.2239 5.40342 13.6709 -8.7699 -31.8396 -11.1478 +592 1 13.3799 12.1942 14.3144 0.413244 -2.26196 2.0512 +593 2 13.2473 11.2333 14.3131 -4.23433 1.2327 0.0241848 +594 2 13.7366 12.3802 13.4362 1.03232 3.06063 -1.77089 +595 1 14.6196 9.43974 7.2819 12.1284 19.1611 12.5008 +596 2 15.4631 9.9012 7.50833 -13.143 -10.3991 -7.78335 +597 2 13.9498 9.89967 7.80701 0.241302 -5.62146 -3.59828 +598 1 12.6688 16.8855 3.24635 -1.47445 -34.5545 -0.541717 +599 2 12.9124 17.3724 4.01195 4.0393 16.1159 25.6755 +600 2 12.6994 17.4999 2.53895 -2.71389 24.0914 -25.4271 +601 1 1.00064 7.12258 17.3474 25.8989 -13.4919 10.9638 +602 2 0.199171 6.81692 17.7654 -17.9333 6.12878 2.90109 +603 2 0.781412 7.72916 16.646 -4.92956 7.36441 -13.84 +604 1 12.947 4.88013 15.7213 -21.2986 7.3754 -0.931645 +605 2 13.7769 4.45629 15.8524 19.8874 -20.9291 -0.114876 +606 2 13.1805 5.80207 15.7513 2.74699 20.2475 2.05037 +607 1 2.36441 3.38825 5.1495 13.4973 -9.76059 -50.575 +608 2 1.87697 2.96062 5.81278 -27.3053 -18.1487 33.2377 +609 2 2.7907 4.09602 5.58982 16.1263 32.9476 11.4061 +610 1 8.23368 10.9868 13.6471 -16.5646 12.9957 -7.98974 +611 2 8.32411 10.9316 14.5895 -0.490848 -4.77914 16.6738 +612 2 9.07298 10.6867 13.3074 11.7511 -8.07538 -9.61613 +613 1 13.0107 1.52025 13.2616 -13.3177 -0.0328213 18.9383 +614 2 13.4383 1.61013 12.4179 13.267 -2.68379 -13.3373 +615 2 12.5185 2.34771 13.3673 3.11016 -7.04189 -1.75869 +616 1 6.59377 13.5764 2.15874 -7.12741 11.9903 -27.1264 +617 2 6.00679 13.9468 2.8128 -10.8754 6.0075 10.3445 +618 2 7.2163 13.0692 2.66145 9.56033 -10.8956 7.78491 +619 1 15.8548 6.42593 12.5881 24.8624 13.3217 16.2273 +620 2 16.4838 6.96617 12.0488 -16.1868 -9.65605 6.77151 +621 2 16.2214 6.49686 13.512 -7.09801 -2.27572 -23.2114 +622 1 16.7956 0.692247 9.54535 7.46915 17.7641 2.49637 +623 2 16.5452 18.5156 9.96298 -0.0131793 -20.516 -0.238231 +624 2 16.2976 0.789947 8.72228 -2.61192 -2.24486 -4.75056 +625 1 6.11318 11.627 8.27064 9.91462 44.2797 -2.20509 +626 2 5.35292 11.2978 8.70378 -29.3613 -6.33495 17.8965 +627 2 6.52877 10.8496 7.97791 23.4734 -34.8725 -13.0112 +628 1 2.81389 8.67751 0.381383 10.1752 -8.74242 -1.84173 +629 2 2.33278 8.32184 18.2713 -4.10181 -2.8979 1.44899 +630 2 2.25425 9.35695 0.757627 -6.74555 6.18422 5.10447 +631 1 10.1136 10.3815 6.5683 -3.97178 -1.84722 1.40214 +632 2 10.6776 9.73953 7.0164 -1.23094 -3.31757 4.86865 +633 2 10.3499 10.3203 5.64027 4.41826 3.29106 -4.73543 +634 1 6.84727 15.7748 6.6764 -14.7135 -11.7826 9.04786 +635 2 7.02398 16.1904 7.53289 5.38031 2.81892 -3.47781 +636 2 6.91879 16.4549 5.99719 9.07918 3.78678 -4.16926 +637 1 6.52182 12.8956 5.7943 0.541827 3.55761 1.99739 +638 2 6.55778 13.7774 6.19915 3.14226 -1.33255 -2.96851 +639 2 6.13082 12.3068 6.44859 -0.859963 5.03094 3.84811 +640 1 16.7567 12.5314 9.76383 -4.64367 0.23861 8.75508 +641 2 16.9908 11.8798 9.10281 -4.06168 -8.34407 -5.30318 +642 2 17.2898 13.2837 9.5332 2.7418 12.1851 0.697411 +643 1 6.23186 2.86269 2.75104 2.97881 8.48666 -1.38882 +644 2 6.52094 3.78037 2.52233 -11.0321 -17.6889 -1.77294 +645 2 5.63962 2.52843 2.04764 8.59188 6.36028 2.68011 +646 1 10.7835 3.03466 3.2504 -5.97107 -1.61798 -4.71292 +647 2 10.2628 3.82076 3.45136 1.61481 0.158577 0.983482 +648 2 10.306 2.59283 2.52669 4.73542 2.88639 2.9637 +ITEM: TIMESTEP +80 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.82629 6.70343 17.8553 -15.1071 8.15122 13.6853 +2 2 7.99416 6.85162 18.349 10.9787 -1.12299 -6.8679 +3 2 8.57507 6.09547 17.1643 3.5075 -8.11573 -6.04158 +4 1 0.137192 8.33532 6.74353 12.0191 -20.4001 -6.39938 +5 2 0.250097 8.10589 5.79669 -2.0008 6.10915 10.6578 +6 2 0.653601 7.63933 7.2162 -12.3825 18.3147 -3.0068 +7 1 8.60149 0.29664 6.93203 12.1667 -9.17994 12.1946 +8 2 9.52501 0.228788 6.64808 -5.75422 4.1152 -0.42095 +9 2 8.21226 0.977159 6.3883 -5.16274 6.48178 -7.47064 +10 1 6.50463 1.68869 11.7262 -16.2706 -7.92373 -2.85274 +11 2 5.9813 2.3145 12.2428 -2.71472 -2.47934 -1.80386 +12 2 5.86927 0.986784 11.4354 16.7384 10.0214 6.53226 +13 1 6.9131 5.55027 2.37535 3.77295 -5.39511 9.11334 +14 2 6.43692 5.84081 3.17655 -0.921031 3.98795 -14.1822 +15 2 6.69543 6.14979 1.6478 1.12895 -1.48609 4.32855 +16 1 16.196 10.2371 16.1388 -31.5516 2.77844 19.9706 +17 2 16.8915 10.3643 15.5412 37.4 6.14414 -23.2997 +18 2 15.8469 11.1288 16.3108 1.55641 -10.2432 -3.37881 +19 1 10.775 14.9631 2.31622 -5.5944 -0.094079 7.63582 +20 2 10.598 14.4521 3.12767 5.78422 3.02899 -5.84463 +21 2 11.1066 15.8146 2.64245 2.43259 -3.51347 -1.1859 +22 1 17.165 8.21001 10.8825 14.1674 -5.9779 -9.25967 +23 2 16.5809 8.83567 11.3092 -8.03296 12.2385 6.15632 +24 2 17.9797 8.71133 10.6858 -5.20793 -0.650283 -1.86008 +25 1 14.6097 15.9558 16.401 14.8916 -7.54315 9.24646 +26 2 13.6847 16.2494 16.4321 3.25844 -2.02272 0.00765398 +27 2 14.8063 15.4932 17.2527 -13.7355 5.39716 -16.4095 +28 1 12.117 13.3155 0.580411 -1.24587 -0.207976 3.78722 +29 2 11.7909 13.4576 18.3369 0.57388 -2.32058 -15.0609 +30 2 11.6242 13.9531 1.10951 4.78037 0.383607 7.31905 +31 1 9.34228 5.488 3.85121 53.6451 1.51077 14.3512 +32 2 8.91013 5.51861 4.6996 -19.4462 -5.34697 10.1126 +33 2 8.70488 5.4763 3.16894 -36.9473 -0.666442 -22.4182 +34 1 1.61615 3.95559 11.5848 -7.57046 15.5603 -11.9076 +35 2 1.66987 4.89506 11.8258 -4.51216 0.523906 3.16779 +36 2 2.10845 3.4705 12.2371 10.5178 -10.3797 12.993 +37 1 2.10284 6.89743 8.15957 -0.837321 -0.675751 7.8246 +38 2 2.47895 7.28827 8.96165 1.07034 3.30836 -6.30935 +39 2 2.071 5.95646 8.37348 -2.86121 -4.48577 -0.939591 +40 1 5.32433 4.44486 7.86972 -1.34052 23.2477 3.45796 +41 2 5.46877 3.5107 7.98026 -0.0649778 -19.4924 -5.7669 +42 2 4.70188 4.60713 7.1427 0.919422 -2.43856 3.29815 +43 1 3.32435 2.88678 17.4197 -1.88929 -9.6261 16.8991 +44 2 4.05816 3.29734 16.977 14.1471 9.33662 -16.3951 +45 2 2.86083 3.59453 17.8818 -3.32176 6.96255 1.50629 +46 1 7.47308 5.51417 6.17701 6.20604 7.73103 -29.885 +47 2 7.95124 6.07722 6.78768 5.01174 3.41934 10.0258 +48 2 7.09189 4.79949 6.66958 -7.20601 -9.71089 14.7057 +49 1 9.80158 6.99902 12.0223 -22.5784 -4.24274 -21.2019 +50 2 10.1069 6.1805 11.5916 -0.00510546 9.67372 7.70676 +51 2 9.03411 7.28611 11.4542 20.6129 -4.31213 14.2424 +52 1 14.1091 3.78361 8.12438 -15.7573 21.5912 -11.6445 +53 2 13.5201 4.50308 7.77049 18.8532 -19.0333 8.38218 +54 2 14.3457 4.04736 9.022 0.199067 1.13361 3.22772 +55 1 4.50215 17.2152 3.88612 2.87802 -1.37968 10.5361 +56 2 5.34021 17.6676 3.86593 13.8498 1.95887 5.68097 +57 2 3.97594 17.6789 3.24294 -11.45 0.485265 -14.6478 +58 1 16.2741 16.534 10.4726 -5.67102 -12.8311 -21.8814 +59 2 15.486 16.5615 11.0293 -1.33881 1.5325 0.205711 +60 2 15.9943 16.0074 9.67798 5.00326 13.1852 19.554 +61 1 1.98121 4.83276 0.125548 -2.90665 -21.863 0.561723 +62 2 2.62989 5.11603 0.769738 5.61812 10.8419 9.00632 +63 2 1.75087 5.59897 18.2498 0.950825 13.4626 -6.91806 +64 1 11.2654 13.2951 16.4195 -4.34554 -2.68737 -1.67212 +65 2 10.7681 12.4683 16.4833 0.87563 -1.05494 5.85319 +66 2 11.8765 13.1105 15.7039 6.19214 3.55339 -6.25188 +67 1 10.1028 10.9035 16.8331 17.2825 8.49241 1.71185 +68 2 10.5205 10.0327 16.7798 -0.767632 10.3686 4.9905 +69 2 9.17724 10.7556 16.7424 -24.4211 -4.37906 -2.41009 +70 1 11.8507 17.4827 13.4696 7.63981 7.03239 -1.88788 +71 2 12.509 16.94 12.9947 -8.02315 8.08552 1.57387 +72 2 12.1795 18.4053 13.408 -3.08283 -9.25718 -0.840972 +73 1 6.44601 9.4433 12.2773 8.37995 -15.986 -34.1351 +74 2 7.00514 9.1357 11.5138 -12.9725 10.8563 23.5312 +75 2 7.03346 9.94503 12.8365 5.04668 8.97956 7.26084 +76 1 16.2979 12.8575 2.71922 -11.7369 16.949 2.19382 +77 2 17.1652 13.221 2.45954 -10.8006 -1.31331 4.0939 +78 2 15.6758 13.6404 2.78783 18.0783 -23.2667 -2.52892 +79 1 0.707968 12.7192 5.87585 -9.46746 -3.17244 -7.34712 +80 2 1.05314 12.7932 4.98248 12.8843 -1.39545 -4.60697 +81 2 18.4375 12.4692 5.68303 -3.12969 3.97578 10.4064 +82 1 5.29671 16.347 18.4316 -9.43352 6.10902 0.949816 +83 2 5.62099 15.5668 17.9615 5.22561 3.70018 3.69326 +84 2 5.92538 16.5961 0.477291 0.486221 -4.47534 -1.04063 +85 1 0.707184 7.70367 4.119 -51.5024 -35.8612 26.1825 +86 2 0.14378 7.97362 3.40377 -12.5647 4.97441 -12.5535 +87 2 1.50957 8.08535 3.91273 65.7491 26.1316 -14.6887 +88 1 3.20348 9.03456 6.50534 -36.9666 27.611 -24.7826 +89 2 3.63112 8.56754 7.174 27.0077 -25.2244 35.3222 +90 2 2.25579 8.96355 6.72902 9.17057 2.1904 -6.46933 +91 1 7.27937 10.3761 16.2413 -0.230914 -4.48303 6.76598 +92 2 6.52755 10.9587 16.1419 -2.56448 5.11938 -3.06937 +93 2 7.11485 9.96393 17.0986 -0.495486 0.80288 1.59662 +94 1 11.0332 0.910989 5.0177 -6.88619 -3.17881 -8.23488 +95 2 10.972 1.75479 4.54866 7.92386 3.49104 7.17877 +96 2 10.6826 0.325395 4.32946 5.79259 -4.26916 6.55693 +97 1 4.2654 2.89302 13.1773 0.694211 20.6748 -2.64105 +98 2 4.39238 3.45448 13.9576 1.0821 -9.7456 0.782255 +99 2 4.16489 1.98946 13.4871 -0.702651 -10.6992 3.24412 +100 1 8.43419 10.272 1.79599 3.30535 -21.7188 -14.6566 +101 2 8.19585 10.8779 2.48837 0.0509316 11.2873 19.613 +102 2 8.53541 9.39344 2.20281 2.46081 9.96427 2.84146 +103 1 10.2486 1.68186 15.4597 -14.9494 5.38019 -3.47887 +104 2 11.0964 1.37036 15.7536 17.388 -0.916576 -1.92962 +105 2 10.2694 1.89097 14.5087 2.57313 -1.10767 6.05091 +106 1 2.6143 12.7739 7.92246 0.947228 -0.997667 -1.9326 +107 2 3.16975 13.4683 7.54148 -0.729705 2.73148 -0.490338 +108 2 1.96608 12.5591 7.23618 1.36975 0.244975 0.56737 +109 1 3.86268 11.7535 5.00307 -14.4028 -3.16999 8.33757 +110 2 3.70976 11.1475 5.74815 1.12966 3.67823 -8.44516 +111 2 3.06255 11.7297 4.44022 7.7842 4.67892 9.37694 +112 1 6.76061 14.5167 16.9537 -0.888094 -7.58336 -2.84579 +113 2 7.48488 15.1306 17.0914 4.64858 -1.1877 -1.93173 +114 2 6.56705 14.5225 16.0035 -2.02875 6.77169 3.29706 +115 1 14.2034 14.5245 3.20058 -0.0398844 -12.3077 5.38397 +116 2 13.8793 15.4221 3.34301 -5.62621 -2.27359 -1.58508 +117 2 13.7959 13.9448 3.87781 2.42748 11.415 -6.18352 +118 1 8.70505 18.0887 16.0942 -64.5065 -8.09898 -3.91687 +119 2 9.21396 17.4083 16.5058 25.0639 -11.349 2.42178 +120 2 9.16407 0.206988 15.7928 30.835 22.2192 -2.21878 +121 1 4.63692 1.68417 4.88655 37.1566 -9.63698 -3.58798 +122 2 3.87701 2.22405 4.82391 -30.2785 19.7734 3.84799 +123 2 5.28246 2.1077 4.29595 -5.87377 -5.36693 3.35208 +124 1 15.0131 12.6297 16.4887 -20.293 3.22713 36.7225 +125 2 14.5244 12.6173 17.3484 21.3151 5.53737 -15.2497 +126 2 14.2857 12.586 15.869 -0.208138 -0.973548 -24.0506 +127 1 15.729 18.4304 16.8576 -8.95075 23.4819 -17.3869 +128 2 16.2245 18.5231 17.6612 15.7889 -2.20706 14.0604 +129 2 15.4698 17.5226 16.786 -7.06215 -23.0828 1.02158 +130 1 1.394 1.31209 16.6703 -16.8241 -3.16738 2.04331 +131 2 2.15084 1.87826 16.8449 0.715689 -4.34048 -2.49358 +132 2 0.715561 1.66179 17.2756 6.00571 -5.18273 -5.07353 +133 1 18.2252 4.3402 15.9772 -8.55569 -2.73 -13.6324 +134 2 17.823 3.76125 15.3072 5.10239 5.23383 8.49054 +135 2 0.492866 4.4785 15.7127 2.39871 -0.864238 1.29175 +136 1 12.1265 17.032 16.1255 -25.5416 -7.58495 15.967 +137 2 11.3669 16.5924 16.5691 16.6277 5.86514 -1.80192 +138 2 11.8242 17.0598 15.2127 8.00105 4.8532 -10.0676 +139 1 16.1291 2.68344 18.211 0.375456 -13.3929 15.5569 +140 2 15.6138 3.3874 18.6109 -0.098248 15.4546 -4.83257 +141 2 15.8549 2.61026 17.3068 -10.5356 1.78345 -20.9571 +142 1 6.60182 13.7939 10.068 9.2492 3.65708 4.18485 +143 2 6.57275 13.4224 10.9661 -3.78941 -3.14938 -5.19226 +144 2 6.71396 13.0652 9.44214 -7.17216 -3.95227 2.85982 +145 1 10.1302 18.5571 2.70452 28.7428 2.61674 -1.08827 +146 2 10.6588 0.134354 1.90491 -8.77267 0.774664 16.1596 +147 2 9.28539 18.2699 2.40893 -22.5926 -9.32297 -10.0302 +148 1 3.0625 17.7033 6.15366 -32.6923 -3.28618 14.6113 +149 2 2.13754 17.6931 5.7562 38.9757 -0.864197 5.33283 +150 2 3.7049 17.7316 5.44436 -0.964713 0.371031 -13.1926 +151 1 12.6087 16.7853 7.93012 21.3772 -3.32102 -23.3093 +152 2 11.8409 16.2517 7.71322 -11.0279 -6.8961 6.738 +153 2 12.4183 17.3739 8.65053 -14.1479 13.0972 16.1976 +154 1 14.9031 15.2939 8.2802 -30.4011 23.5185 11.3145 +155 2 14.1656 15.9721 8.20757 23.4522 -23.8051 0.0341398 +156 2 15.3634 15.3182 7.4362 3.9964 4.48103 -1.46252 +157 1 17.8706 18.2596 0.245663 2.0948 -17.0514 -11.0411 +158 2 18.6148 17.6985 18.5349 -15.5847 20.6608 16.06 +159 2 18.229 0.448391 0.574358 6.37924 -1.254 -0.87753 +160 1 0.806491 10.487 1.42673 -7.2326 -9.98023 10.4462 +161 2 -0.00161399 9.98055 1.66044 10.6613 4.25192 -4.69396 +162 2 0.557346 11.1929 0.820979 -4.09494 2.43397 -4.83249 +163 1 1.83456 12.2686 3.29043 -8.34448 2.57963 -8.45001 +164 2 1.36787 11.5875 2.7525 13.033 10.6511 2.37549 +165 2 2.15971 12.967 2.6794 -8.27007 -10.3927 7.15994 +166 1 0.688934 17.2807 4.96532 -1.28513 13.5074 -14.6034 +167 2 -0.0176841 17.9487 5.11769 8.40666 -17.1979 3.35047 +168 2 0.596617 16.4414 5.43231 -12.6974 4.79178 9.39957 +169 1 1.09014 0.907525 9.3383 6.29421 1.3921 30.3575 +170 2 1.25758 0.656293 10.2983 -10.9635 5.07818 -25.2558 +171 2 0.281108 0.475301 9.05696 -4.67463 -4.0945 4.23309 +172 1 16.7684 2.39691 13.3495 9.61769 42.5491 2.72371 +173 2 16.904 2.78957 12.4595 -0.731435 -13.0756 10.2936 +174 2 16.527 1.48948 13.2642 -5.98641 -27.7824 -4.48506 +175 1 2.71373 15.9459 12.053 -3.75115 0.267025 20.4445 +176 2 2.98439 15.5717 12.9162 -2.14108 4.62523 -16.3505 +177 2 3.30112 15.6057 11.3695 4.80572 -2.00813 -1.58569 +178 1 16.3912 15.5658 6.1364 -18.5193 -23.7813 -1.39285 +179 2 17.3153 15.4712 6.31079 23.2449 0.130836 8.54259 +180 2 16.3263 16.278 5.5153 -3.20698 17.7917 -15.4301 +181 1 5.73039 5.21537 11.7967 -2.24013 5.33831 8.85226 +182 2 5.58704 6.03693 12.3192 -1.36073 -15.5687 -10.3459 +183 2 5.0707 4.59019 12.1393 4.45693 0.898588 -6.68224 +184 1 15.134 4.90094 0.781902 20.2218 -12.3751 4.08616 +185 2 14.9115 4.68422 1.69179 -1.28767 -2.72314 10.4735 +186 2 14.3889 5.35469 0.437757 -23.5901 14.4279 -10.7703 +187 1 16.3592 16.4594 1.89384 25.1746 19.6936 -18.9686 +188 2 16.2469 16.8 2.79117 -6.86302 3.67352 0.481682 +189 2 16.829 17.1783 1.36994 -16.7874 -21.2348 17.437 +190 1 0.175681 4.85349 3.94905 -38.6563 1.2533 -4.07114 +191 2 0.373462 5.78529 3.89581 11.5619 13.3417 2.94095 +192 2 0.969717 4.36237 4.02266 30.2668 -11.0427 7.4994 +193 1 2.99204 15.0813 15.1763 -0.305205 14.4793 -34.7595 +194 2 2.88713 14.6595 16.0135 -9.94348 -6.29569 26.5741 +195 2 2.4481 15.8945 15.1967 6.07768 -3.34342 6.9782 +196 1 1.12287 14.6661 9.5226 42.1359 23.511 16.8308 +197 2 2.04871 14.8527 9.88052 -40.3465 -4.39318 -17.9218 +198 2 1.08708 13.7187 9.50981 -4.88478 -15.9854 1.2011 +199 1 13.5299 16.5144 11.5405 11.2356 18.9117 4.33104 +200 2 13.1159 17.2557 11.0661 2.81218 -0.6798 2.92705 +201 2 13.1037 15.7572 11.1579 -10.8238 -16.1215 -4.14744 +202 1 4.70977 1.52963 0.718559 3.58248 -24.4192 11.8527 +203 2 4.08939 1.89433 0.0933404 -5.33693 14.3563 -9.66083 +204 2 4.20955 0.796838 1.1277 3.32575 8.01941 1.68952 +205 1 1.50238 18.6141 11.9042 -1.38031 13.5472 16.8753 +206 2 1.45658 0.425239 12.7856 -0.241625 -6.75063 -24.7438 +207 2 2.14944 17.9089 11.9973 -1.06457 -6.06855 3.15913 +208 1 11.4462 10.1354 4.10554 -27.8103 0.519562 13.0103 +209 2 11.5399 10.6236 3.29381 1.04561 4.25273 -17.1067 +210 2 12.3232 9.96387 4.39943 30.3669 -4.33072 3.08727 +211 1 8.16113 12.1728 3.80004 4.97071 -3.14572 14.2587 +212 2 8.9952 12.5305 4.11747 11.4774 1.91239 -11.4095 +213 2 7.64202 12.24 4.61417 -11.8418 -2.63078 -6.07404 +214 1 14.5844 4.03291 3.36716 -4.11232 -3.55002 -24.3582 +215 2 15.2517 4.33672 3.97304 10.7234 0.0718586 14.5399 +216 2 13.7453 4.32617 3.71649 -8.9869 4.72015 4.68372 +217 1 5.72064 1.64489 7.5839 32.9059 28.6425 0.0988457 +218 2 5.06921 1.12259 7.98588 -34.2591 -28.2453 24.4599 +219 2 5.39575 1.74393 6.6993 -3.28926 -2.3453 -25.2911 +220 1 17.8815 1.07824 4.83341 -4.77439 -8.44394 -0.469265 +221 2 18.4195 1.29399 4.06103 3.32925 4.9906 2.38586 +222 2 18.1973 1.60106 5.58304 1.56226 2.04575 -0.708791 +223 1 6.854 9.3046 4.53528 10.3956 -9.62802 3.27507 +224 2 6.69426 9.36632 5.492 2.76918 3.19153 -6.51095 +225 2 7.80605 9.0738 4.45229 -13.5827 1.70924 -0.808399 +226 1 2.59539 14.8276 2.04954 -21.4179 -5.20739 -34.911 +227 2 3.34516 14.7063 2.60932 22.2061 -1.352 15.1427 +228 2 2.90646 14.7931 1.11821 -3.29515 2.22824 22.2692 +229 1 17.3057 12.9587 13.1574 -14.3584 11.8265 -1.68619 +230 2 16.4238 13.3017 13.4505 21.6076 -1.54195 -11.2195 +231 2 17.8123 13.7306 12.814 -13.7958 -9.76612 7.37248 +232 1 14.8715 10.5568 1.52593 -13.8049 33.9422 19.399 +233 2 15.3968 11.3309 1.89043 -12.48 -24.7346 -11.1652 +234 2 13.9264 10.776 1.72699 26.333 -7.21409 -8.066 +235 1 5.65075 6.69227 4.53589 -1.16643 0.470211 -4.08107 +236 2 5.90168 7.60385 4.33311 1.92457 3.57872 5.04239 +237 2 6.31691 6.35225 5.15026 1.24698 1.28263 2.78678 +238 1 8.00933 8.29789 10.2803 -8.03608 2.46456 2.45807 +239 2 8.54459 8.86115 9.67988 -10.051 -7.82575 5.32423 +240 2 7.18397 7.98917 9.84875 17.8376 0.213066 -8.74409 +241 1 13.4452 18.4811 5.71348 30.3006 1.0471 -14.1486 +242 2 12.642 0.299737 5.48582 -19.0854 8.92614 -0.688815 +243 2 13.1967 17.7426 6.25238 -10.7462 -10.7439 19.4962 +244 1 -0.0119027 2.59488 0.354931 35.8038 -39.8932 13.3955 +245 2 17.7273 2.51611 0.10594 -24.5443 11.4005 -8.19311 +246 2 0.27212 3.48779 0.285479 3.99253 30.2779 -6.4317 +247 1 12.849 10.869 9.75158 -6.21929 20.5855 -7.88953 +248 2 11.8713 10.9784 9.78619 15.6811 -13.8069 -0.457669 +249 2 13.0615 9.92753 9.83861 -13.7986 2.36182 2.76964 +250 1 0.623186 12.214 11.083 4.78072 12.4497 9.66308 +251 2 18.3291 12.2937 11.2784 -7.07035 -2.86266 -6.1852 +252 2 1.03568 12.566 11.8864 5.16139 -3.44089 -5.05626 +253 1 5.24317 7.35288 13.329 16.5645 10.6427 9.86574 +254 2 5.81232 8.06371 12.9598 -16.2044 -6.02954 3.80806 +255 2 5.63373 7.21351 14.2126 -3.74153 -4.80134 -10.81 +256 1 1.17457 6.8033 11.9036 -23.8679 10.4664 -9.71638 +257 2 0.289623 7.06715 11.5324 26.398 -8.64759 11.7652 +258 2 1.56564 7.61974 12.2537 0.753648 -2.9175 -1.70229 +259 1 15.4919 9.76734 12.3795 0.0614124 -7.36309 3.05776 +260 2 15.0846 10.6319 12.2391 7.36463 -2.83561 -3.47144 +261 2 15.8873 9.82027 13.2467 -0.105969 -0.524429 6.2821 +262 1 16.5022 12.5635 5.51418 5.92626 -4.93161 -13.1981 +263 2 16.3002 13.4761 5.69188 -2.75562 16.3616 9.80459 +264 2 16.3759 12.5305 4.55079 1.66896 -8.7704 1.12914 +265 1 6.31756 9.85145 0.122373 -12.0354 8.37982 6.54531 +266 2 5.4699 10.2439 0.423151 12.3884 -4.45977 -3.2374 +267 2 6.98984 10.1338 0.758446 2.49067 2.04662 0.271789 +268 1 12.1918 6.08954 4.01066 -16.388 -25.9861 2.6766 +269 2 12.1912 6.72626 3.29268 0.559249 7.6643 3.09763 +270 2 11.3251 5.63233 3.94387 14.2823 13.1494 2.08097 +271 1 0.332379 12.8663 0.0441745 0.0508304 2.00456 8.93046 +272 2 18.9019 13.5185 0.756349 -7.27218 -2.99587 0.981784 +273 2 18.3327 13.1573 18.0278 2.80865 -1.79272 -4.8195 +274 1 3.54313 0.0443203 8.66238 11.9606 -6.13667 -3.48184 +275 2 3.32458 18.1774 7.87344 8.237 1.02812 -5.83338 +276 2 2.68777 0.391851 8.89446 -8.31408 9.03305 4.42594 +277 1 7.44404 17.5122 4.49167 0.119683 3.6114 3.91179 +278 2 7.85567 18.3869 4.65486 -14.0238 -13.6963 -7.23825 +279 2 7.39901 17.3877 3.53399 5.58618 2.96743 1.37553 +280 1 9.26713 17.153 12.2094 -20.2295 17.8608 7.81194 +281 2 9.28392 16.3133 11.7674 1.3049 -15.888 -12.5165 +282 2 10.076 17.208 12.7094 15.0452 0.291548 7.10451 +283 1 13.4068 13.0832 7.92217 -6.10698 -2.73533 15.5952 +284 2 13.4694 12.4257 8.66119 -0.459118 13.24 -15.7611 +285 2 13.8946 13.8972 8.17425 4.86633 -17.7849 -1.17812 +286 1 14.7977 2.95386 15.4326 21.7471 11.1646 11.1554 +287 2 14.1505 2.32893 15.1446 -13.9872 -17.9607 -8.38755 +288 2 15.4352 3.02911 14.7173 3.23846 -4.77681 -7.04868 +289 1 9.91022 15.6467 16.9338 -7.88269 11.4297 -3.43074 +290 2 10.0979 14.7902 16.532 6.40878 -6.10819 3.84543 +291 2 9.43747 15.4751 17.7557 1.6004 -7.26983 6.6271 +292 1 11.2148 8.51865 16.6243 -9.14606 -19.2231 -14.9185 +293 2 10.4285 8.06123 16.2547 13.8022 0.848227 5.21642 +294 2 11.6642 7.88268 17.1928 -1.33785 -0.880144 3.29074 +295 1 3.96477 18.2022 16.8388 0.151724 27.8243 14.0652 +296 2 4.47646 17.6367 17.4198 3.54357 -14.0579 0.0762873 +297 2 4.08749 0.446059 17.2373 -6.51294 -16.617 -15.0442 +298 1 2.23636 4.23466 8.90617 11.6474 4.96614 0.176633 +299 2 3.18727 4.06881 8.84702 -5.0902 0.586039 -2.82984 +300 2 2.03755 4.18072 9.84669 -2.61694 -5.47133 1.10155 +301 1 9.89683 10.3797 9.78633 12.6385 -21.4053 -24.2531 +302 2 9.49137 11.1552 9.42946 -10.1833 20.5571 -3.63947 +303 2 9.86232 10.3926 10.7266 0.554165 3.61624 28.8421 +304 1 9.72109 0.91625 10.832 13.6195 9.02414 1.59857 +305 2 9.21789 0.206273 11.2536 -3.38139 -4.49977 -6.76529 +306 2 9.17946 1.37162 10.1615 -3.40595 -8.11879 6.74876 +307 1 9.15707 15.1255 10.1914 20.6551 -3.22149 9.33909 +308 2 9.01609 15.916 9.68312 -8.41387 13.877 -8.61246 +309 2 8.34011 14.6408 10.1195 -14.233 -7.19689 -0.719266 +310 1 0.808146 9.70808 10.2086 23.84 -38.9856 -20.0319 +311 2 0.930598 10.6496 10.3444 5.65872 6.03362 4.8682 +312 2 1.64643 9.29884 9.83207 -32.5144 23.6532 16.8406 +313 1 17.0698 4.80337 8.05752 27.8638 -35.1931 -3.66362 +314 2 16.2966 5.30586 8.21629 -27.2809 18.9512 9.97555 +315 2 16.9993 3.9693 8.55928 -0.62818 15.8913 -5.61459 +316 1 14.8223 14.6574 0.153467 -11.4546 -14.4551 -9.90243 +317 2 15.436 15.0274 0.766448 14.8773 15.1477 17.5942 +318 2 14.121 14.2916 0.705806 -3.92817 0.026116 -2.07816 +319 1 3.85634 11.0156 9.57857 3.75671 2.20251 0.903354 +320 2 3.89754 11.3203 10.4983 -5.37308 2.01291 2.42961 +321 2 3.35837 11.6719 9.06911 -6.8083 1.73507 0.204751 +322 1 11.3728 10.7464 1.42992 33.2497 -4.81825 9.44885 +323 2 11.5281 11.6383 1.10055 0.915848 5.55374 -4.33141 +324 2 10.4426 10.6155 1.47257 -31.1398 -0.627116 -5.41705 +325 1 13.1828 7.20447 12.6676 -0.0478479 -14.2604 -0.4669 +326 2 14.1298 6.99811 12.5505 -7.76827 -0.67018 4.43892 +327 2 12.735 6.32848 12.7534 7.45412 15.7346 -2.47341 +328 1 9.63194 1.91441 0.890304 3.16134 4.31897 -8.70512 +329 2 8.77158 1.63222 0.526893 10.8452 7.48256 0.350857 +330 2 10.2032 2.19638 0.151243 -8.90992 -2.48069 6.74103 +331 1 10.6318 13.4626 4.55882 -11.5056 -1.99047 12.5083 +332 2 11.4876 13.0509 4.71851 7.47615 -1.29416 -2.63952 +333 2 10.4232 13.8662 5.41293 0.691023 4.41994 -1.81408 +334 1 14.5517 1.66181 10.9802 -11.5576 12.9 9.45395 +335 2 15.3776 1.3055 10.6442 8.04202 2.4344 -3.19562 +336 2 14.6907 2.6148 11.169 4.38713 -8.31284 -15.1855 +337 1 14.4901 12.0498 11.5809 -31.454 -4.77499 25.6083 +338 2 15.091 12.4736 11.0015 28.7023 12.1919 -21.8177 +339 2 13.8321 11.6274 11.0162 -1.74489 3.16984 -4.97875 +340 1 8.17369 5.13537 9.87952 -12.8505 7.96449 12.3464 +341 2 7.30162 5.126 10.3345 14.626 0.500686 -8.94194 +342 2 8.32701 4.24033 9.57061 -3.03583 -8.79147 -1.32617 +343 1 1.61182 16.9829 18.4557 19.3906 15.8485 -25.2691 +344 2 2.09739 17.4464 17.7224 -9.17701 -12.9822 18.3353 +345 2 1.80792 16.0477 18.3234 -0.14796 -4.92565 -1.79656 +346 1 1.43858 17.3769 15.3174 -8.9259 8.94647 7.52005 +347 2 1.45812 18.1702 15.9147 -6.93156 -15.9408 -17.1792 +348 2 0.507347 17.0882 15.1685 14.4449 8.30676 8.33907 +349 1 3.5257 5.78471 6.06613 -3.39677 -13.3058 1.89016 +350 2 2.9753 6.46227 6.46115 -3.38454 1.41808 7.55669 +351 2 4.15739 6.26663 5.53865 9.2569 4.30143 -12.1591 +352 1 12.629 9.51298 14.2604 -9.77978 19.3775 3.35531 +353 2 12.9437 8.76225 13.7938 15.2815 -22.6591 -22.819 +354 2 12.3447 9.10922 15.0729 -6.56341 1.36458 18.6396 +355 1 4.0928 15.2431 7.0497 -2.25109 -22.7738 13.7055 +356 2 3.66448 16.0653 6.81785 -2.80743 13.3283 -7.68 +357 2 5.04695 15.3859 7.01583 3.36741 6.66555 -6.63338 +358 1 0.780201 8.79903 15.0924 -4.1065 -28.223 6.26572 +359 2 0.548696 9.72105 15.1288 -1.34907 18.7642 -4.10325 +360 2 1.5752 8.72345 14.5481 -0.207921 7.22304 -3.82448 +361 1 12.9286 8.29499 10.1476 33.3114 -28.911 32.5654 +362 2 13.7554 7.80683 9.90421 -18.1809 10.2081 -7.43875 +363 2 12.9042 8.10572 11.1188 -9.83308 4.93442 -19.3471 +364 1 15.2998 7.93844 3.50826 -21.0939 -7.00262 -11.8412 +365 2 14.4558 7.58878 3.24395 -11.6977 10.4201 -28.099 +366 2 15.3831 7.3862 4.26257 30.2163 -1.92794 33.2483 +367 1 17.18 6.71526 18.6425 -0.133844 12.8911 -12.7702 +368 2 16.7451 5.93694 0.322596 -6.25651 -15.7248 7.28694 +369 2 16.4413 7.25778 18.3094 9.30548 1.37884 5.01187 +370 1 8.9084 6.99396 7.88573 -0.881002 2.32267 0.0260346 +371 2 9.83584 7.2627 7.79742 -0.0847644 -0.13812 3.11438 +372 2 8.83558 6.46246 8.69404 -0.0294368 0.694249 -1.22754 +373 1 12.437 0.501834 1.22358 -0.716997 -8.58934 -9.29719 +374 2 13.1312 1.05983 1.5788 8.89791 0.478791 5.50433 +375 2 12.732 0.307907 0.326573 -3.73597 1.67796 1.81541 +376 1 5.69458 15.0516 14.5143 3.69591 -14.2553 -4.53333 +377 2 4.76954 15.0969 14.776 -8.31751 1.66253 0.63197 +378 2 5.95328 15.9515 14.3109 5.80865 11.3045 -3.56535 +379 1 3.78081 6.42509 1.75203 4.2348 -8.30075 -4.29513 +380 2 3.33672 7.18396 1.37288 -3.60544 13.0853 -6.67388 +381 2 3.84967 6.63422 2.68491 0.545892 0.795555 6.86444 +382 1 3.88792 11.3989 12.3546 13.0971 -5.24635 -8.64578 +383 2 4.74838 11.8202 12.5261 -6.66532 -1.91753 0.168546 +384 2 3.23677 11.927 12.8169 -5.64663 9.70313 4.55872 +385 1 5.30252 3.85246 15.7701 3.45242 11.6571 4.53522 +386 2 6.06202 3.27771 15.61 2.30678 -4.65184 -5.35711 +387 2 5.68598 4.72788 15.9368 -2.89319 -4.23448 -3.12102 +388 1 14.1378 10.1309 4.62741 -6.40911 2.93718 -21.1253 +389 2 14.285 9.82325 5.50803 7.98673 -9.05047 24.7099 +390 2 14.6717 9.53242 4.07811 -2.84302 6.29722 1.17771 +391 1 7.65634 17.3346 9.10408 10.3132 -24.7491 -1.74792 +392 2 7.07794 17.6856 9.78277 -9.16436 8.21537 0.604828 +393 2 7.96278 18.0151 8.50473 -0.553145 15.1908 -4.94918 +394 1 4.52232 14.5173 3.95827 12.1345 -25.6108 -47.7046 +395 2 4.42958 15.3956 4.25649 -1.76895 36.8878 18.7873 +396 2 4.4098 13.9051 4.66351 -3.8607 -15.3504 25.5968 +397 1 14.1258 7.45828 15.8364 -6.23365 -6.73609 3.75314 +398 2 14.9302 7.39167 15.3277 7.57838 -0.290505 -5.08612 +399 2 14.4287 7.78058 16.69 -2.09073 5.34234 4.78248 +400 1 2.95098 18.3751 1.91859 -29.5535 -1.78839 -16.8987 +401 2 2.45071 17.8858 1.20736 17.1758 4.42604 21.0133 +402 2 2.2449 0.246547 2.36374 11.8246 -5.6794 -7.15496 +403 1 7.99154 1.5773 4.49846 30.6245 -5.45524 3.73918 +404 2 7.42382 1.97686 3.83614 -1.09908 5.00667 -8.45405 +405 2 8.90683 1.55308 4.13454 -22.7919 6.21994 3.05753 +406 1 2.44336 14.1732 17.7263 2.89693 8.8065 2.99283 +407 2 1.80182 13.5359 18.0713 -0.462046 0.279758 -5.24045 +408 2 3.30188 13.814 17.96 10.6791 -8.66055 4.12847 +409 1 0.94217 1.90899 13.8934 13.5408 -1.52741 -1.05885 +410 2 1.19747 1.57322 14.7589 -4.95142 3.16298 5.50662 +411 2 18.6373 2.03702 13.8998 -8.7871 -0.483879 -2.02084 +412 1 4.30938 0.151078 13.8855 7.43827 7.09651 -9.2822 +413 2 5.23906 18.5299 13.9426 -3.76642 -3.92995 -1.86801 +414 2 3.88869 18.4591 14.673 -3.49259 -4.03929 12.0029 +415 1 7.32054 0.93366 18.4163 -33.3446 -10.4004 5.92831 +416 2 7.32153 0.654144 17.4916 5.03052 -1.00997 0.0977128 +417 2 6.36163 0.937686 18.6972 26.0729 9.45288 -6.86634 +418 1 15.8933 18.4156 13.9169 -22.9956 8.12347 -47.8741 +419 2 14.9583 18.5802 13.6337 24.0447 -6.26997 16.1472 +420 2 15.9487 18.2637 14.8423 -3.56821 2.97357 29.888 +421 1 10.2651 4.57121 16.2688 1.93413 -35.0494 -13.7078 +422 2 11.2092 4.46181 16.4883 -7.31309 8.12251 -3.69007 +423 2 10.0229 3.6678 15.9192 2.49448 27.3645 14.4368 +424 1 15.9059 17.707 4.46041 -10.2591 -26.7612 -3.24664 +425 2 16.489 18.4443 4.44561 19.3223 26.1038 4.21423 +426 2 15.1093 18.0276 4.88994 -9.23113 3.77657 -1.20249 +427 1 6.91304 17.5561 13.9404 -32.5423 1.81832 8.8205 +428 2 7.45718 17.7359 14.6891 13.6263 3.56972 27.349 +429 2 7.55119 17.4736 13.2627 22.9256 -5.60471 -32.7019 +430 1 13.1887 6.46821 6.52506 2.14134 -6.99498 -16.9539 +431 2 14.1468 6.55272 6.36688 -10.1834 4.86047 2.66897 +432 2 12.7776 6.33144 5.63446 11.1073 4.86992 20.3892 +433 1 7.86929 2.3014 9.43186 -7.43999 -0.581733 -7.42672 +434 2 7.28758 2.26368 10.206 1.54253 -4.13193 1.23421 +435 2 7.37428 1.85692 8.71867 3.17855 7.90221 2.8646 +436 1 15.2039 14.7441 13.779 -1.62406 2.57688 -1.70285 +437 2 14.9354 14.9492 14.6806 -4.8726 3.09257 3.44485 +438 2 14.7582 15.3762 13.1995 0.661267 -3.02741 1.58802 +439 1 9.4149 8.38535 3.859 -25.1665 -10.991 -5.57318 +440 2 10.2049 8.88585 3.99067 20.2759 12.8236 2.22258 +441 2 9.67249 7.46496 3.96553 -1.56288 -2.67339 -2.00262 +442 1 17.7026 13.5834 16.4242 -1.80346 -11.0476 6.4727 +443 2 16.7549 13.3713 16.3986 -0.662501 7.25922 -2.44544 +444 2 17.8485 14.4294 15.9813 -4.13054 1.45271 -4.35383 +445 1 4.91191 10.5224 2.88074 35.1139 -21.7488 -13.7776 +446 2 5.74832 10.1175 3.20879 -18.1595 7.39309 -6.65206 +447 2 4.64711 11.0636 3.60968 -4.98951 12.9254 11.8317 +448 1 3.70989 8.40692 9.9178 -3.43098 -13.3807 16.77 +449 2 3.72102 9.34916 9.72654 3.49477 5.64054 -2.09668 +450 2 3.74613 8.34545 10.8924 -2.49133 1.09455 -12.0955 +451 1 15.9811 6.93645 5.90716 -9.64967 -5.56515 0.983492 +452 2 16.7246 7.40088 6.29715 7.31355 3.31596 3.21676 +453 2 16.2311 6.00551 5.84179 2.78737 3.87161 -3.53071 +454 1 15.2416 7.2288 8.97537 -25.1477 -13.3308 -14.4253 +455 2 15.9965 7.60799 9.37505 30.1105 10.4166 22.3283 +456 2 15.0439 7.80906 8.23828 -3.19363 1.15625 -6.55237 +457 1 6.20437 12.8345 12.7354 -14.1465 10.1654 -16.7884 +458 2 6.94522 12.3758 13.1101 18.4885 -10.5564 10.7987 +459 2 6.04629 13.6348 13.2503 2.66058 2.52169 8.79246 +460 1 12.1262 4.55048 13.1243 17.0811 13.049 12.1055 +461 2 12.3395 4.65477 14.0809 -9.37635 -6.07885 -14.152 +462 2 11.329 4.03313 13.0256 -8.31182 -5.5816 3.57791 +463 1 11.4354 8.07801 7.94226 -0.810806 3.70784 -8.7596 +464 2 12.2037 7.66847 7.47953 -11.1819 -0.00285319 12.9065 +465 2 11.6202 8.13058 8.89801 9.03316 -1.52538 -12.7532 +466 1 16.9943 10.8342 7.6109 -5.03955 -8.49642 17.9987 +467 2 17.7716 10.3123 7.42961 10.8043 -13.0503 -0.479497 +468 2 16.9113 11.4133 6.86596 -8.14606 13.8231 -19.3584 +469 1 5.21042 18.0585 10.7699 15.6232 7.92267 2.97831 +470 2 4.74775 17.5474 11.4283 -5.6196 -5.04348 5.46467 +471 2 4.57391 18.2408 10.077 -8.01525 -1.2934 -10.8517 +472 1 7.60043 17.4332 1.64042 6.79415 6.05281 -21.827 +473 2 7.93761 16.6332 1.20425 2.91062 0.230192 8.27204 +474 2 7.75711 18.1408 0.980897 -9.32049 -5.6032 10.0359 +475 1 1.93897 12.9382 13.63 3.13689 -3.11692 -16.6768 +476 2 1.43678 12.3217 14.1546 -10.1951 -7.38374 9.42459 +477 2 2.04891 13.7234 14.1672 6.66588 6.79896 5.37665 +478 1 9.3938 6.77683 14.8244 15.3217 -3.43003 -1.39025 +479 2 9.8639 6.00007 15.2423 -8.39432 15.0581 -15.9266 +480 2 9.75443 6.97816 13.9251 -4.83499 -14.7492 16.6004 +481 1 15.2802 4.37234 10.7612 17.1837 -0.598437 7.1821 +482 2 16.2442 4.23454 10.6079 -20.4209 -0.451849 5.19081 +483 2 15.2528 4.98337 11.5249 -0.66536 -5.42981 -12.7574 +484 1 11.4105 6.21551 0.0734026 -8.7314 7.93342 -2.27424 +485 2 11.3895 5.26963 0.0141504 12.2817 -18.3718 -0.889513 +486 2 10.499 6.41528 18.4856 -6.56297 9.87049 -0.998012 +487 1 18.513 11.4235 14.9225 12.9282 -22.681 3.72438 +488 2 17.9895 11.7369 14.1972 -5.90482 9.25399 -19.4183 +489 2 18.3571 12.0937 15.574 -0.537982 14.5307 17.0247 +490 1 7.08328 9.28085 7.30918 -19.7197 4.18214 5.56511 +491 2 6.73297 8.51044 7.78417 1.76821 -0.286333 -7.5509 +492 2 8.01676 9.1548 7.24802 24.3996 -5.081 -1.83944 +493 1 18.3255 15.3437 12.2137 -3.8694 0.735905 0.400418 +494 2 0.599616 15.5 11.9645 6.26195 2.32841 -0.363056 +495 2 17.7995 15.7522 11.5099 -2.40985 0.96637 0.371307 +496 1 16.511 4.37404 5.22763 -21.2214 -5.51878 25.3236 +497 2 16.4647 3.99489 6.12381 2.74309 1.28503 -9.80457 +498 2 17.4303 4.54035 5.0616 22.4703 -0.915278 -13.9933 +499 1 17.7218 3.13981 10.7749 -4.33552 13.9915 6.34554 +500 2 18.6231 3.34836 11.0663 1.21144 -2.68719 -3.11144 +501 2 17.734 2.28626 10.3485 2.99182 -14.4528 -5.38806 +502 1 12.2792 18.655 10.1327 17.2693 -45.8263 -15.1364 +503 2 11.5058 0.449575 10.4425 -26.2107 18.2097 8.79889 +504 2 13.0094 0.611642 10.1232 12.3896 24.8189 4.81349 +505 1 10.4214 9.73086 12.5154 -11.4047 -1.1898 4.78042 +506 2 11.1516 9.87418 13.1364 2.96428 -4.00819 -1.03044 +507 2 10.2474 8.77319 12.4992 9.30457 6.64045 -3.3636 +508 1 0.651598 2.68478 7.18172 -17.9134 21.5061 -11.8097 +509 2 0.347525 3.6016 7.34273 5.69642 -14.867 -2.54197 +510 2 0.849668 2.34638 8.05251 8.91351 -8.30419 8.52406 +511 1 0.318497 15.272 6.90444 -3.43175 -0.902574 -18.2314 +512 2 0.478582 15.5644 7.78858 6.40513 2.68345 23.4663 +513 2 0.623162 14.3599 6.89897 0.272636 -4.92753 -7.69196 +514 1 17.0533 6.94572 15.0273 7.81631 0.565766 -0.894277 +515 2 17.8128 7.55845 14.958 -6.36521 -5.11302 -0.197876 +516 2 17.4132 6.11744 15.3876 -1.58799 4.21551 0.905627 +517 1 9.15046 12.5368 8.00027 -36.358 14.0028 8.44058 +518 2 9.59383 11.9142 7.43445 3.21629 -19.4527 -15.2125 +519 2 8.22229 12.648 7.66907 25.8785 -7.47424 5.38289 +520 1 1.16102 1.67919 2.79298 -14.264 -19.5534 -4.4961 +521 2 1.06769 2.21394 1.99483 -1.93616 3.76767 1.09072 +522 2 1.84572 2.00753 3.35812 13.0572 19.5695 8.60311 +523 1 4.13351 15.1441 9.8761 6.18483 -5.86151 -6.61306 +524 2 3.91524 15.1965 8.93344 2.62784 3.42174 0.908977 +525 2 5.03514 14.7702 9.87632 -7.63961 1.62567 3.94135 +526 1 7.3909 2.2738 14.7748 9.28558 9.05007 -9.33433 +527 2 7.12441 1.5503 14.2057 -1.53405 -3.63662 -1.19206 +528 2 7.87829 2.88836 14.1809 -18.0097 -8.54319 17.0088 +529 1 18.3492 14.5565 2.15246 12.0934 24.362 7.12212 +530 2 0.551729 14.8667 2.53499 -6.69921 -6.84856 -6.85574 +531 2 17.7888 15.364 2.12839 1.3753 -15.6354 -3.85708 +532 1 10.0163 2.6808 12.9164 -0.493731 -5.11601 -9.40492 +533 2 9.92018 2.0572 12.1601 0.76191 10.4011 8.73608 +534 2 9.26265 3.29452 12.869 4.65507 -2.10266 -3.09911 +535 1 2.95427 8.9021 13.1034 24.5728 -3.04867 -5.91166 +536 2 3.51177 9.68096 12.817 -20.8286 -16.9148 9.19061 +537 2 3.59809 8.18481 13.2917 -7.73525 14.463 -2.49767 +538 1 3.26448 8.6069 3.78485 -10.2248 -21.121 34.5648 +539 2 3.76672 9.19042 3.24166 13.0731 20.305 -12.8555 +540 2 3.48359 8.83627 4.72374 -5.93153 -5.30867 -25.3462 +541 1 5.8473 7.24819 8.6208 2.3932 7.90906 9.86277 +542 2 5.81432 6.28497 8.53212 -5.5277 -2.57364 -0.635967 +543 2 5.0659 7.54439 9.12071 1.08185 -7.49096 -4.29671 +544 1 14.8764 1.57981 1.83846 12.2497 10.4795 -14.7641 +545 2 15.1104 2.2908 2.43504 -9.02026 1.90223 13.0204 +546 2 15.3525 1.8445 1.03212 -8.04537 -15.132 5.23431 +547 1 8.61698 15.0264 0.696156 7.89205 -2.64916 2.43147 +548 2 9.41092 14.8348 1.25307 -18.4618 8.30064 -5.38467 +549 2 7.89576 14.464 1.0316 3.03152 0.23278 2.41128 +550 1 15.4513 1.4301 7.20503 6.99627 -6.82188 0.69389 +551 2 14.8244 0.90582 6.69357 -2.8394 0.789398 0.0418873 +552 2 15.0149 2.26607 7.38205 -7.95005 6.31947 4.24803 +553 1 4.96675 12.927 18.445 -0.392058 -1.0762 11.0005 +554 2 5.34886 12.9244 0.695922 -4.30965 1.19363 -4.30526 +555 2 5.68 13.266 17.9034 2.74534 3.65082 -4.88489 +556 1 15.3953 8.66034 18.0902 -2.07624 -16.7815 -3.18775 +557 2 15.9144 9.19311 17.4724 -5.66293 4.97787 2.21077 +558 2 15.1583 9.22886 0.188985 2.48846 7.45062 3.31632 +559 1 12.0359 3.11648 18.28 -8.04977 7.84102 -5.19135 +560 2 12.2901 3.11968 0.565205 5.43673 -10.4163 -2.44039 +561 2 12.4787 2.41139 17.7764 2.20222 0.638625 8.9068 +562 1 13.1884 12.6911 5.14611 -2.25763 -6.31837 -0.123489 +563 2 13.4652 11.7849 4.90596 3.78769 10.9202 3.38983 +564 2 13.3386 12.7839 6.10454 1.74722 -2.69816 -5.37077 +565 1 6.12211 7.19464 0.152335 -0.889801 -16.5081 12.3486 +566 2 6.2475 8.12337 19.0248 -9.08967 1.02729 -5.81202 +567 2 5.35557 6.85974 0.666933 3.80599 9.00251 -10.0268 +568 1 17.6814 15.8746 14.896 -32.95 0.345881 -9.96463 +569 2 16.7135 15.9334 14.9982 15.4899 6.1636 11.5551 +570 2 17.7111 15.6936 13.9484 19.9419 -0.275145 -3.25111 +571 1 13.1284 0.88699 16.7751 -4.95458 6.20661 5.10718 +572 2 14.0638 0.660956 16.7688 7.30918 -0.228866 0.981928 +573 2 12.6898 18.6827 16.6682 -2.70263 -7.7996 -4.366 +574 1 10.8711 14.4993 7.46323 15.7126 -17.3597 -1.2585 +575 2 10.128 14.0173 7.85917 4.58757 6.56369 -3.56814 +576 2 11.6082 13.8461 7.48059 -10.4237 16.2655 0.791757 +577 1 17.6751 8.40087 2.13849 -13.7675 10.6042 3.42109 +578 2 16.7708 8.37025 2.51335 11.2555 0.423493 -3.0905 +579 2 17.6147 7.881 1.33167 1.95975 -7.58305 -2.5048 +580 1 12.424 7.82566 2.03348 6.80204 18.2298 -3.36389 +581 2 12.2928 8.74872 1.74157 -3.31877 -9.32949 5.70746 +582 2 11.9673 7.27395 1.39444 0.405274 -3.29714 -11.9602 +583 1 12.0088 14.6056 10.3972 49.4943 -15.6831 -19.0447 +584 2 12.4654 14.316 9.56616 -19.1829 7.51475 23.0356 +585 2 11.0956 14.6861 10.1978 -35.275 4.57666 -6.07844 +586 1 6.81054 6.90501 15.534 -24.6279 -1.31201 9.93627 +587 2 7.70831 7.14913 15.3109 11.0416 1.99651 0.427612 +588 2 6.48555 7.50951 16.2192 7.91049 -4.43387 -1.91407 +589 1 7.94039 4.47545 13.2332 14.4982 34.8647 21.806 +590 2 7.26408 4.6474 12.5684 -6.44209 3.92223 0.968251 +591 2 8.05746 5.34482 13.7439 -3.25809 -36.365 -21.9094 +592 1 13.3499 12.2014 14.3127 -1.24116 1.37617 13.1465 +593 2 13.3241 11.2332 14.3368 -6.04942 0.470969 -4.28371 +594 2 13.6308 12.4336 13.4212 3.90264 0.498209 -3.09495 +595 1 14.5954 9.45997 7.28998 13.2192 -1.86441 -1.0042 +596 2 15.4197 9.90762 7.5754 -11.2574 0.0534663 -4.99205 +597 2 13.8535 9.8793 7.72336 -3.17401 5.05716 8.17378 +598 1 12.6619 16.8656 3.26711 -0.0867316 -13.7478 -1.21165 +599 2 12.9036 17.3981 4.01825 1.80146 10.547 8.89773 +600 2 12.7645 17.4143 2.493 -0.0316456 12.4477 -7.66427 +601 1 1.00141 7.10091 17.3455 15.3286 -2.27437 -0.63111 +602 2 0.197357 6.73674 17.6796 -23.7065 -4.2556 16.6559 +603 2 0.696205 7.72166 16.6912 7.12828 11.4292 -16.7267 +604 1 12.984 4.84784 15.752 -30.1278 -7.6986 -1.85236 +605 2 13.773 4.32613 15.627 12.1969 -0.534485 4.03194 +606 2 13.2127 5.76882 15.785 16.3015 19.3583 1.60965 +607 1 2.35806 3.40155 5.13736 7.00458 -19.3644 -43.6846 +608 2 1.86996 2.9687 5.81855 -13.4119 -5.52905 24.958 +609 2 2.73401 4.18924 5.49805 8.9837 23.3098 13.0491 +610 1 8.19273 10.9521 13.6844 -8.81681 4.64201 23.2716 +611 2 8.19092 10.7627 14.6526 -0.424045 0.881441 -21.4162 +612 2 8.95149 10.4932 13.3231 15.2004 -1.23984 -4.72202 +613 1 13.0449 1.52469 13.2577 -17.2068 8.30684 11.3152 +614 2 13.5293 1.59874 12.4201 -3.55841 -0.219514 3.90721 +615 2 12.4208 2.28784 13.3343 18.9425 -17.4385 -9.09999 +616 1 6.61166 13.6023 2.12464 -9.14589 11.0627 -26.7302 +617 2 6.03511 14.0379 2.75872 -4.67031 1.02227 7.02539 +618 2 7.1693 13.0213 2.62577 8.97168 -8.12604 14.3361 +619 1 15.8326 6.37868 12.5447 13.0084 18.5244 20.7727 +620 2 16.3675 6.96965 11.9727 -5.6566 -10.5049 5.53461 +621 2 16.1589 6.56267 13.4684 -3.25982 -7.33208 -24.589 +622 1 16.7829 0.679169 9.53725 3.65315 -1.00951 10.2573 +623 2 16.653 18.4141 9.83094 1.34292 -7.75704 2.15353 +624 2 16.269 0.772043 8.73148 -3.87084 4.41009 -12.8197 +625 1 6.12871 11.643 8.2509 28.8456 37.0564 -10.7514 +626 2 5.32101 11.4251 8.67159 -25.2961 -16.2243 16.4685 +627 2 6.59615 10.8374 8.068 1.48557 -20.4229 -4.39625 +628 1 2.81588 8.6455 0.385911 -12.1168 -14.4708 -15.8933 +629 2 2.2408 8.27575 18.315 12.5525 5.70225 18.3425 +630 2 2.25296 9.2478 0.88122 -2.81952 5.7616 1.15354 +631 1 10.1112 10.3249 6.56463 -6.88185 10.2676 4.3595 +632 2 10.6724 9.72741 7.0699 2.3169 -7.24343 0.885556 +633 2 10.4905 10.3984 5.68005 1.7842 -2.70629 0.197339 +634 1 6.85117 15.7741 6.71172 -4.51814 -4.38518 8.0947 +635 2 7.10947 16.276 7.50071 -0.280141 -2.70051 -1.05147 +636 2 7.0022 16.3747 5.97143 2.95927 2.8361 -5.64101 +637 1 6.55245 12.8624 5.85582 3.66478 4.31955 2.99752 +638 2 6.71899 13.7301 6.24424 -0.933807 5.79026 -3.46681 +639 2 6.12481 12.3549 6.55179 0.263982 -0.200358 2.15574 +640 1 16.7435 12.5401 9.7846 -13.9618 -8.21713 16.7649 +641 2 16.8388 11.8663 9.10427 2.99064 0.578166 -4.74348 +642 2 17.1608 13.3339 9.48085 7.01955 11.3182 -8.14386 +643 1 6.27773 2.82725 2.7475 -16.1332 4.52919 -16.5002 +644 2 6.37029 3.76301 2.48637 6.52487 -6.75351 6.59876 +645 2 5.7241 2.45518 2.0296 8.37538 -0.331655 9.00677 +646 1 10.7419 2.97566 3.2545 -3.93098 2.36946 -8.35386 +647 2 10.3631 3.83794 3.45313 -5.44824 -1.84651 0.91029 +648 2 10.2755 2.65841 2.45654 4.06882 -1.04864 5.83378 +ITEM: TIMESTEP +90 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.80968 6.6261 17.8375 -14.5778 0.995444 8.41947 +2 2 7.95772 6.60642 18.3334 15.3437 1.8775 -14.2431 +3 2 8.74654 5.99095 17.1112 1.57504 -1.57025 6.7209 +4 1 0.142832 8.36014 6.73441 10.0116 -15.4349 27.0014 +5 2 0.232649 8.20449 5.79462 4.11725 -7.32768 -11.6468 +6 2 0.67494 7.65251 7.20998 -18.6261 25.5606 -16.1468 +7 1 8.65703 0.380136 6.98192 16.3005 -1.0776 2.50655 +8 2 9.57515 0.309779 6.66722 -10.0942 0.994659 4.05519 +9 2 8.27212 1.03395 6.395 -6.58679 0.322126 -3.42087 +10 1 6.47941 1.69165 11.7468 2.00503 -21.4393 -6.03474 +11 2 5.9725 2.29393 12.2744 -13.1143 10.2157 7.12378 +12 2 5.89376 0.920881 11.5936 7.71629 6.15291 -2.33076 +13 1 6.9103 5.50063 2.38437 -35.7814 23.4203 2.69428 +14 2 6.20944 5.92743 2.96221 29.3961 -15.7919 -7.47581 +15 2 6.73166 5.94071 1.53167 10.6635 -7.16691 8.95661 +16 1 16.211 10.2361 16.1124 -22.7966 -2.93172 13.0323 +17 2 16.937 10.2632 15.5246 28.6916 5.0146 -15.8412 +18 2 15.9737 11.152 16.3021 -3.36115 -0.429235 -4.16748 +19 1 10.8196 14.9788 2.33309 -6.31813 -9.42536 4.48609 +20 2 10.7437 14.525 3.19227 -2.25161 -0.175376 -6.3843 +21 2 11.168 15.8375 2.56675 6.6431 8.63317 3.56201 +22 1 17.1655 8.21466 10.9616 20.3007 -11.9207 -19.649 +23 2 16.6876 8.89778 11.4174 -14.8371 14.2918 8.905 +24 2 17.9353 8.67496 10.5709 -5.82559 -3.7293 4.59063 +25 1 14.5981 15.9748 16.3536 13.4587 -18.0704 19.8012 +26 2 13.6875 16.2688 16.3636 -10.2246 8.72504 -7.33216 +27 2 14.6733 15.4751 17.2031 2.63957 5.2712 -15.5493 +28 1 12.1292 13.2811 0.580093 14.6523 -12.0599 13.1814 +29 2 11.875 13.3883 18.3092 -10.372 6.98394 -12.7652 +30 2 11.639 13.8901 1.1449 -2.74566 6.59249 -3.74219 +31 1 9.34925 5.48981 3.82539 12.3818 -0.191077 28.8485 +32 2 8.80634 5.44704 4.61652 7.17551 -1.92534 15.5524 +33 2 8.65833 5.42982 3.20736 -26.4153 -0.989629 -43.3837 +34 1 1.57757 3.9189 11.5719 -21.368 33.8782 -18.8992 +35 2 1.50486 4.82423 11.9434 2.77 -7.29772 -4.79385 +36 2 1.95891 3.38097 12.2317 20.2106 -22.0339 29.781 +37 1 2.11583 6.92705 8.12278 -10.2704 -2.23476 -15.4196 +38 2 2.47676 7.42607 8.85663 6.65774 -1.70501 8.2798 +39 2 2.06913 5.99576 8.38149 2.03129 -2.32531 8.57063 +40 1 5.2846 4.43559 7.83749 -11.1092 26.0267 -7.92074 +41 2 5.42959 3.50305 7.74019 3.58921 -20.4287 3.63869 +42 2 4.59753 4.67739 7.1831 9.16507 -0.464339 6.41033 +43 1 3.36483 2.87842 17.4354 -5.48754 -0.0293267 11.8999 +44 2 4.0122 3.13798 16.7945 16.5223 13.9802 -16.1706 +45 2 2.91387 3.69111 17.7275 -1.08839 -5.27878 2.29607 +46 1 7.51128 5.54904 6.16479 9.71808 2.6671 3.00483 +47 2 8.12131 6.08033 6.71556 -9.69992 -1.44216 -4.10694 +48 2 7.04033 4.98631 6.78947 -1.48399 -2.17988 -0.0590646 +49 1 9.79239 7.0023 12.0333 -12.7203 -1.67256 -9.54047 +50 2 10.0574 6.1295 11.7028 -2.54946 7.94968 0.438659 +51 2 9.0334 7.28866 11.4661 15.1177 -5.87574 8.09476 +52 1 14.1269 3.84395 8.13857 -24.8841 12.3935 -19.8999 +53 2 13.4363 4.47719 7.80064 24.2741 -16.3277 6.83338 +54 2 14.3749 4.15432 9.00462 4.04893 6.4318 14.0535 +55 1 4.52686 17.2232 3.85531 -7.09571 -9.71268 16.0786 +56 2 5.35353 17.6803 4.02689 3.89364 6.28665 -2.88462 +57 2 3.96567 17.7155 3.24673 4.45666 4.6431 -9.26961 +58 1 16.1958 16.5107 10.5377 18.4287 -13.9772 -31.1199 +59 2 15.4454 16.6557 11.0933 -16.6117 1.05393 13.9092 +60 2 15.8645 15.9242 9.81336 4.55855 15.7974 16.2758 +61 1 1.967 4.85121 0.0645769 9.40837 -19.0171 0.778776 +62 2 2.73793 5.10942 0.56616 3.15966 4.76786 17.0447 +63 2 1.80075 5.61055 18.1709 -12.801 18.3624 -15.2179 +64 1 11.1737 13.314 16.4367 2.74473 1.78814 5.72217 +65 2 10.7128 12.4641 16.5748 8.32361 2.87799 -7.58216 +66 2 11.8417 13.1969 15.7431 -5.18043 -7.14508 -0.417807 +67 1 10.0458 10.8999 16.8205 33.4394 -5.51473 9.19041 +68 2 10.5428 10.0531 16.9406 -15.1708 22.1127 -3.77119 +69 2 9.12902 10.6892 16.7607 -22.7906 -6.8787 -3.44008 +70 1 11.889 17.5084 13.4814 3.48745 6.24304 -13.0003 +71 2 12.5913 17.1622 12.8998 -9.91022 -4.16273 6.93206 +72 2 12.0139 18.4633 13.4204 2.43964 2.21886 2.73389 +73 1 6.44228 9.49569 12.2996 9.71147 -12.8692 -34.1322 +74 2 7.06965 9.17025 11.5988 -17.7592 6.4035 17.1392 +75 2 6.97144 10.0526 12.8659 4.91959 6.23922 4.73193 +76 1 16.3022 12.832 2.75135 -12.5209 9.65366 -4.24277 +77 2 17.1598 13.1655 2.44684 -4.70434 0.462679 5.46936 +78 2 15.6996 13.6248 2.74248 12.9928 -20.5688 3.1232 +79 1 0.706696 12.7395 5.83755 -10.6776 2.47735 15.1944 +80 2 1.02688 12.9731 4.95908 -4.07327 -10.4263 -9.29508 +81 2 18.3891 12.5308 5.80039 14.5368 6.4085 -10.1514 +82 1 5.29875 16.3254 18.4501 12.7507 -5.44046 -6.67673 +83 2 5.72604 15.6129 17.9385 -8.69196 7.59677 5.8406 +84 2 6.01274 16.6418 0.375909 -8.3334 1.51688 4.30584 +85 1 0.743878 7.68205 4.10167 -26.7478 -30.2572 33.4946 +86 2 0.179417 7.92019 3.37827 -7.5716 9.21403 -16.4097 +87 2 1.60385 7.98113 3.89879 36.269 17.899 -12.2731 +88 1 3.22103 9.09598 6.53924 -28.7289 15.6764 -27.4701 +89 2 3.63534 8.61301 7.2251 9.03881 -15.9481 23.3571 +90 2 2.25678 8.88215 6.53178 21.3431 5.76786 5.41461 +91 1 7.2773 10.3926 16.241 -1.60955 -9.9776 11.4431 +92 2 6.63502 11.108 16.2935 -0.090439 -0.440245 3.15105 +93 2 7.09074 9.80627 16.9963 -3.87073 10.8392 -3.46734 +94 1 11.0095 0.891279 5.03438 2.23591 -17.8064 16.3849 +95 2 10.8775 1.7336 4.57918 5.69275 -3.07397 -7.72854 +96 2 10.7003 0.188666 4.43596 -0.931337 13.9517 -3.17827 +97 1 4.21583 2.94335 13.1635 9.62289 2.41259 16.4284 +98 2 4.47922 3.3428 14.0131 -5.18172 -0.255184 -10.0037 +99 2 4.1364 2.00091 13.3783 -2.2119 -1.88246 -4.82143 +100 1 8.45625 10.2801 1.81127 9.01648 -22.0588 9.24648 +101 2 8.30671 10.8697 2.54783 -2.77767 16.2884 7.52121 +102 2 8.66335 9.4444 2.27657 -0.852681 8.00384 -10.6723 +103 1 10.2261 1.659 15.4538 -6.06042 8.31352 -11.6288 +104 2 11.1361 1.48308 15.6359 20.1952 -3.56794 7.64131 +105 2 10.2187 1.98601 14.5369 -5.79366 -2.30068 5.3707 +106 1 2.60435 12.742 7.94637 -6.15341 0.568057 0.983218 +107 2 3.03975 13.5699 7.72118 6.64853 3.0435 -2.79803 +108 2 1.95513 12.6117 7.24141 1.86204 -3.09485 1.26562 +109 1 3.88579 11.7956 5.01149 -19.6155 -13.0634 1.96641 +110 2 3.74363 11.1082 5.69355 0.727972 11.568 -8.07528 +111 2 3.05901 11.8342 4.47209 17.5209 1.69759 11.0979 +112 1 6.76239 14.55 16.9383 -0.403452 -2.75277 4.08609 +113 2 7.61561 14.9826 17.0312 2.52456 -1.29817 -0.221044 +114 2 6.44911 14.7692 16.0549 2.09428 -3.60588 -3.74869 +115 1 14.1942 14.5231 3.16652 -5.12336 -14.4242 4.12891 +116 2 13.6899 15.3256 3.31261 0.149267 9.23779 -5.23449 +117 2 13.7696 13.8761 3.7521 4.09464 2.97302 0.255936 +118 1 8.7401 18.0877 16.1157 -15.0544 -15.1521 5.72203 +119 2 9.42706 17.4939 16.3945 -6.08837 -23.732 7.70311 +120 2 9.27218 0.11536 15.7481 8.35971 40.209 -14.9349 +121 1 4.63391 1.71898 4.89 36.0507 -5.82478 -13.0459 +122 2 3.81997 2.19927 4.85319 -16.3674 13.8452 0.00946397 +123 2 5.20292 2.04685 4.14723 -16.8402 -3.94878 19.5369 +124 1 15.0105 12.65 16.5031 22.0082 2.89039 39.0948 +125 2 14.6032 12.5883 17.4132 0.919275 4.87615 -33.2046 +126 2 14.3966 12.5461 15.7793 -22.8851 -3.84554 -8.75239 +127 1 15.7197 18.424 16.8504 13.0838 27.0964 8.25258 +128 2 16.3964 18.519 17.5419 -1.36847 2.51381 -4.544 +129 2 15.6686 17.4972 16.714 -13.5977 -31.6712 -2.03374 +130 1 1.39308 1.32386 16.6798 -9.07755 4.26299 3.83254 +131 2 2.19455 1.8573 16.8358 -13.1892 -10.0845 0.867767 +132 2 0.760663 1.62622 17.366 11.6728 -4.82483 -8.86289 +133 1 18.2416 4.3099 15.966 -4.36834 -5.16176 -14.6355 +134 2 17.7783 3.61219 15.465 8.57404 10.6893 6.25867 +135 2 0.425079 4.50442 15.5034 -5.04787 -4.14191 4.79432 +136 1 12.0688 17.0582 16.1192 -6.60497 -5.44285 54.7429 +137 2 11.374 16.6436 16.7154 18.2098 8.22439 -32.524 +138 2 11.7541 17.1189 15.223 -7.97888 -4.44492 -17.7493 +139 1 16.0987 2.72798 18.2222 -6.94033 2.52412 -3.34156 +140 2 15.6657 3.49187 18.6187 5.88163 2.98889 4.51464 +141 2 15.8079 2.8031 17.3159 -2.77048 -8.0731 -14.4365 +142 1 6.58612 13.762 10.0351 1.63352 -0.32404 13.73 +143 2 6.39624 13.3299 10.8846 2.34483 4.77487 -0.634471 +144 2 6.55421 13.0562 9.39028 1.369 -6.64332 -8.7831 +145 1 10.1169 18.5721 2.70869 27.9004 -1.02691 -4.20355 +146 2 10.7561 0.140951 1.98734 -15.1054 -0.137902 13.7961 +147 2 9.28626 18.3596 2.30468 -14.2521 -4.05351 -7.65243 +148 1 3.07988 17.6804 6.1902 -35.1734 2.13391 -17.3705 +149 2 2.15682 17.7525 5.8242 24.0448 -4.32039 20.662 +150 2 3.55195 17.7661 5.36197 20.4585 -2.58277 -0.69289 +151 1 12.6061 16.7775 7.89366 1.16584 -8.73771 -17.6522 +152 2 11.856 16.1922 7.7211 -0.763759 -4.24653 -1.89641 +153 2 12.3057 17.3353 8.59898 -2.13454 17.8975 18.5826 +154 1 14.8965 15.3132 8.35277 -22.4274 15.9599 0.214205 +155 2 14.2421 15.9941 8.02515 16.4945 -20.4059 13.6979 +156 2 15.4898 15.1572 7.61828 5.37632 7.31151 -11.1374 +157 1 17.8957 18.2766 0.201476 9.69326 -17.5267 -0.973127 +158 2 18.6995 17.7195 18.781 -12.0492 3.04369 -7.3597 +159 2 18.2321 0.401263 0.645934 -1.5685 17.2308 6.22008 +160 1 0.802158 10.4818 1.45184 -19.0828 -29.4994 30.4216 +161 2 -0.0309651 10.0246 1.77565 29.2477 9.1244 -14.7118 +162 2 0.53478 11.1455 0.834437 -7.87366 18.9841 -18.3051 +163 1 1.85308 12.2863 3.27351 -7.97315 5.10175 -10.2215 +164 2 1.42551 11.5849 2.74616 7.16023 4.54594 2.45335 +165 2 2.09673 12.9814 2.63054 -3.38314 -5.43944 9.55244 +166 1 0.718881 17.2977 4.9616 -19.2906 6.0419 1.76293 +167 2 -0.10575 17.7685 5.12875 8.39755 13.2462 -10.2288 +168 2 0.622971 16.5645 5.55208 6.7728 -21.2776 10.1703 +169 1 1.03867 0.919889 9.35844 3.74022 -6.32288 33.4729 +170 2 1.10918 0.592533 10.3007 6.31379 11.0803 -22.721 +171 2 0.269914 0.464458 9.03134 -8.6906 -2.38217 -7.04515 +172 1 16.7862 2.42581 13.3986 14.7457 27.0937 -15.311 +173 2 16.9847 2.74906 12.4891 -5.29709 -2.40963 18.2684 +174 2 16.5429 1.52129 13.2791 -8.06021 -27.7395 3.47759 +175 1 2.69738 16.0066 12.0777 13.1506 -14.7233 12.6976 +176 2 3.02715 15.5922 12.9029 -9.51867 9.47826 -13.4594 +177 2 3.28974 15.6737 11.3809 -2.31502 2.53439 -1.78657 +178 1 16.3754 15.4917 6.11201 -7.25585 -20.1131 3.67265 +179 2 17.3156 15.5044 6.29369 9.86882 2.22778 5.36532 +180 2 16.2073 16.2228 5.51797 -0.959992 10.1027 -9.31738 +181 1 5.7174 5.24337 11.7813 4.42707 -14.1004 -1.48072 +182 2 5.44277 5.99707 12.328 1.64183 -4.11158 -2.88134 +183 2 5.22325 4.47043 12.1002 -4.92771 7.03451 -4.06757 +184 1 15.1242 4.92712 0.766674 18.5408 -12.9138 10.3204 +185 2 14.9855 4.62556 1.67944 -3.08744 4.9541 4.0864 +186 2 14.3291 5.35182 0.492873 -21.4444 10.4963 -5.72763 +187 1 16.3798 16.4926 1.83048 25.9496 20.3657 -34.7081 +188 2 16.3432 16.8093 2.72897 -9.33108 7.61853 14.7037 +189 2 16.7914 17.2408 1.28765 -16.0156 -28.1785 20.3541 +190 1 0.157471 4.87182 3.99278 -9.81132 22.7056 -3.03191 +191 2 0.5332 5.76253 4.03054 -8.2904 5.08609 0.673103 +192 2 0.911036 4.31937 4.01308 22.6258 -22.4944 4.73784 +193 1 2.97603 15.0857 15.1688 -3.76699 16.0764 -9.28303 +194 2 2.87698 14.8354 16.0845 -1.20729 -14.2266 12.1787 +195 2 2.48786 15.9266 15.1702 1.40562 1.39337 -6.33902 +196 1 1.10637 14.6846 9.51596 31.8836 22.2572 14.4694 +197 2 2.01065 14.9183 9.89233 -34.4229 -12.9306 -18.6629 +198 2 1.03031 13.7317 9.56194 1.94445 -7.79278 4.16037 +199 1 13.55 16.5172 11.5597 10.1041 14.0808 -3.72584 +200 2 13.3442 17.2549 10.9555 -5.19335 -6.01443 7.16005 +201 2 13.1025 15.7566 11.183 -9.96101 -8.306 -1.961 +202 1 4.75563 1.55237 0.702796 10.3802 -26.0161 11.0265 +203 2 4.32304 2.05314 0.014379 -14.7339 5.42124 -2.63334 +204 2 4.14265 0.839056 1.00315 4.15161 14.819 -1.07901 +205 1 1.52656 18.6416 11.9009 -8.95117 16.8483 13.4998 +206 2 1.43825 0.48402 12.7573 3.56637 -8.71242 -18.201 +207 2 1.98334 17.8196 12.0914 3.68072 -6.34965 2.55122 +208 1 11.4393 10.1383 4.17836 -13.7636 4.05009 -8.78245 +209 2 11.3903 10.5027 3.28707 -1.50281 2.58284 -2.63304 +210 2 12.3655 9.96172 4.28712 17.4192 -2.53267 8.67839 +211 1 8.18359 12.1636 3.86104 -21.222 -14.272 -14.5003 +212 2 9.05859 12.5239 4.0446 -0.40723 6.23371 14.3883 +213 2 7.56046 12.2135 4.62832 23.1203 4.46306 -6.77507 +214 1 14.593 4.04535 3.38111 7.28555 -5.40785 -19.1504 +215 2 15.2127 4.15408 4.10794 5.52844 2.67895 3.03112 +216 2 13.7536 4.35259 3.70606 -13.9578 6.65801 6.31365 +217 1 5.72323 1.65443 7.61073 34.4 15.7962 37.2038 +218 2 5.13785 1.03104 8.01585 -19.7408 -11.9782 7.15973 +219 2 5.42676 1.78462 6.74294 -17.7695 -4.7826 -52.6001 +220 1 17.8873 1.06414 4.83181 6.8154 -0.232455 -4.71432 +221 2 18.4369 1.21178 4.04718 -2.79964 -1.76243 2.38037 +222 2 18.3376 1.55744 5.53048 -5.83965 -0.882229 4.9581 +223 1 6.85055 9.23648 4.54341 6.32277 -8.10519 -4.82585 +224 2 6.75809 9.38079 5.49182 3.88959 4.29486 1.07151 +225 2 7.79379 9.02149 4.39148 -10.7358 1.98669 4.12637 +226 1 2.55801 14.782 2.06648 -8.35029 -12.2797 -25.7867 +227 2 3.24533 14.7191 2.71695 15.3489 0.778658 13.055 +228 2 2.98421 14.5338 1.22242 -9.03529 10.4097 12.3511 +229 1 17.2667 12.9721 13.1114 -20.9369 36.2303 -2.57416 +230 2 16.4188 13.4451 13.3365 18.5804 -22.1292 -0.415694 +231 2 17.7749 13.7311 12.7641 -0.529191 -13.9074 0.965338 +232 1 14.8416 10.5583 1.56689 -2.78575 22.6182 14.2458 +233 2 15.4799 11.2066 1.96334 -16.8252 -10.4846 -9.71145 +234 2 13.9405 10.9259 1.71943 20.5685 -8.6057 -5.43477 +235 1 5.6352 6.7176 4.51351 -9.14706 -11.8638 3.15016 +236 2 6.0003 7.60062 4.53525 2.53301 15.852 -6.04122 +237 2 6.16933 6.24394 5.16122 6.25334 -1.18144 -1.3834 +238 1 8.0084 8.26626 10.2701 -4.49752 14.9075 -15.7864 +239 2 8.53054 8.9292 9.77232 -0.437986 -11.1673 11.0277 +240 2 7.35426 7.95022 9.61336 5.97292 -3.64509 13.4454 +241 1 13.4616 18.4657 5.71166 17.1322 -6.35165 -5.45305 +242 2 12.613 0.202175 5.51075 -18.0122 19.0124 -5.00284 +243 2 13.2587 17.813 6.37409 -3.85709 -10.1746 14.3256 +244 1 0.0252945 2.56986 0.408061 0.439602 -5.22175 -5.84652 +245 2 17.7844 2.56336 0.0359587 -11.4993 -5.28871 3.98864 +246 2 0.277142 3.47535 0.26454 16.627 13.7372 -0.461998 +247 1 12.8639 10.8267 9.72576 -55.6075 31.3565 -11.278 +248 2 11.8723 10.9451 9.72713 30.8534 7.0313 -2.47663 +249 2 12.8724 9.89108 9.83244 20.4971 -22.7651 5.79467 +250 1 0.607625 12.2828 11.1117 24.514 -2.72666 -9.78403 +251 2 18.2964 12.3126 11.1603 -11.5713 5.22338 7.13378 +252 2 1.01642 12.6716 11.9034 -8.98148 -2.79725 -0.830812 +253 1 5.29539 7.3549 13.3064 -7.85772 10.5518 3.63543 +254 2 5.70599 8.16396 12.9287 -0.549664 -12.4206 10.9242 +255 2 5.67568 7.22584 14.1948 2.69835 3.31529 -9.72444 +256 1 1.17555 6.77844 11.9244 -33.9372 -12.3631 -14.3141 +257 2 0.259637 6.99751 11.6106 25.929 -3.06653 9.08527 +258 2 1.58097 7.60434 12.1643 7.59492 14.5493 8.35248 +259 1 15.5141 9.76806 12.4302 -1.8656 17.4266 8.04916 +260 2 15.0855 10.6363 12.2204 12.2826 -22.7347 2.36453 +261 2 16.0019 9.91808 13.2494 -6.58523 -0.731675 -3.13373 +262 1 16.4968 12.5534 5.50851 9.37615 -29.7593 -4.66799 +263 2 16.3074 13.4744 5.68685 -5.44524 15.7433 -9.11055 +264 2 16.3732 12.3531 4.54775 0.322938 17.9758 14.7603 +265 1 6.32376 9.8903 0.169934 -28.7401 -0.365509 -5.18995 +266 2 5.50824 10.2805 0.557378 14.6251 -5.00462 -6.15541 +267 2 7.04833 10.2225 0.694867 12.727 0.898893 11.9262 +268 1 12.1515 6.04661 4.01259 -24.0177 -36.8905 11.864 +269 2 12.231 6.67099 3.30768 1.42994 18.9462 -13.2923 +270 2 11.2548 5.64061 3.89367 21.868 15.3866 4.7403 +271 1 0.316109 12.8908 0.0158726 1.97018 -1.90411 4.82087 +272 2 18.784 13.4984 0.752127 -2.36898 -0.989285 -3.79 +273 2 18.4247 13.2164 17.9164 2.23727 -3.47257 5.47524 +274 1 3.55093 0.0615484 8.6771 30.4928 -5.90286 -4.02028 +275 2 3.49841 18.2151 7.84215 -7.8476 4.22576 -1.41638 +276 2 2.7473 0.557235 8.76228 -21.0031 4.54937 0.225707 +277 1 7.3901 17.5352 4.48573 6.23592 32.7201 -14.6481 +278 2 7.69571 18.4853 4.57976 -11.8279 -33.7706 3.32686 +279 2 7.33788 17.4402 3.51852 2.74261 -6.71083 9.2357 +280 1 9.25 17.16 12.2333 -3.7288 14.5824 3.61249 +281 2 9.26512 16.5009 11.5521 -3.80961 -18.6559 -12.0666 +282 2 10.1634 17.2094 12.5273 3.6148 1.53928 10.2644 +283 1 13.402 13.1082 7.90091 0.220655 -14.9059 29.302 +284 2 13.4302 12.436 8.64233 -5.21958 14.4877 -25.9571 +285 2 13.929 13.8525 8.23076 3.39805 -3.2421 -4.10773 +286 1 14.8025 2.90677 15.4495 23.2091 4.40575 2.70159 +287 2 14.1483 2.29946 15.1328 -14.8482 -16.0174 -4.02081 +288 2 15.4935 2.87296 14.7763 0.208871 3.12507 -3.30872 +289 1 9.90762 15.6519 16.9195 -4.56731 4.54647 -2.1455 +290 2 10.1638 14.7845 16.5964 9.48907 -4.21512 -5.5698 +291 2 9.51082 15.4442 17.7618 -6.39245 0.962418 13.4848 +292 1 11.1953 8.50068 16.6178 -6.68582 -9.72424 -8.69684 +293 2 10.4052 8.01271 16.3331 5.65618 1.52157 -2.37675 +294 2 11.7201 7.85843 17.0918 5.14472 -5.56789 7.7477 +295 1 3.97964 18.2216 16.8609 -11.5365 11.132 -5.80894 +296 2 4.44261 17.5481 17.3724 7.79342 1.98205 9.06349 +297 2 4.16759 0.471834 17.2017 1.31413 -17.4358 -0.663005 +298 1 2.27286 4.25928 8.9046 8.30035 -0.830932 12.3077 +299 2 3.22373 4.0264 8.87035 -15.4899 4.40379 3.11293 +300 2 1.97207 4.14495 9.83591 10.7423 -1.42059 -17.2737 +301 1 9.92348 10.3926 9.8203 -1.21029 -1.85278 -24.2235 +302 2 9.36782 11.1029 9.49607 0.630055 7.16446 -2.16893 +303 2 9.82869 10.3844 10.7566 4.49005 -1.30636 29.4196 +304 1 9.77911 0.915187 10.8241 -1.58049 4.53496 -1.50662 +305 2 9.30516 0.126632 11.1017 -0.152878 -7.87834 6.94802 +306 2 9.15539 1.38664 10.2518 4.51752 0.176684 -4.82426 +307 1 9.1489 15.1729 10.179 6.96198 -6.50551 5.53221 +308 2 8.91001 15.8322 9.53904 -4.06695 15.478 -9.20984 +309 2 8.38415 14.5913 10.1616 -4.75674 -5.76082 4.02117 +310 1 0.743465 9.68917 10.1631 30.9903 9.57445 -5.37239 +311 2 0.884314 10.6156 10.4664 -8.35327 -15.1374 -2.2352 +312 2 1.62506 9.41264 9.82336 -24.2866 3.90606 7.18729 +313 1 17.1113 4.7779 8.02102 2.26389 -23.2748 8.45538 +314 2 16.3418 5.309 8.21811 -5.84575 9.78705 2.38191 +315 2 17.0463 3.99595 8.60382 3.74785 14.695 -9.14029 +316 1 14.847 14.6269 0.171171 -19.7527 -14.4968 -14.2937 +317 2 15.5321 14.9161 0.755334 10.0132 13.2257 15.972 +318 2 14.1228 14.2968 0.729437 5.50655 3.69994 -2.14986 +319 1 3.90456 11.0507 9.5998 -4.69832 -0.998696 -0.0493525 +320 2 3.86255 11.1688 10.552 1.28841 5.10968 9.84865 +321 2 3.27063 11.6917 9.24194 0.0177884 -1.71993 -8.82733 +322 1 11.433 10.7439 1.41897 29.5023 2.97313 10.7876 +323 2 11.6019 11.6536 1.12948 3.85703 -2.03295 -2.25776 +324 2 10.504 10.6413 1.35913 -35.0433 -4.68689 -6.35229 +325 1 13.1835 7.21214 12.6412 -8.23521 -20.1104 -3.47812 +326 2 14.127 7.05932 12.5127 3.33109 -0.638199 4.03042 +327 2 12.8061 6.29857 12.6985 3.22225 19.9882 2.50286 +328 1 9.65928 1.95745 0.843925 10.2182 6.36996 -3.06277 +329 2 8.81763 1.63483 0.51897 -5.65357 2.11518 2.03686 +330 2 10.1334 2.26536 0.0610097 2.29468 0.231167 4.03759 +331 1 10.5974 13.4461 4.57973 -2.39764 -3.17335 8.92217 +332 2 11.4415 12.9723 4.66721 0.170993 3.79528 3.71784 +333 2 10.3828 13.7711 5.47244 5.6647 1.39651 -7.04866 +334 1 14.5805 1.64306 10.9903 3.01891 29.9103 -7.34195 +335 2 15.4206 1.31489 10.661 2.43812 -13.4824 -3.17866 +336 2 14.6923 2.61327 10.8523 -8.77415 -13.7688 6.87151 +337 1 14.4577 12.0498 11.5485 -29.7481 -1.24334 12.4997 +338 2 15.1787 12.3182 10.9897 13.6492 5.38623 -14.4259 +339 2 13.7324 11.7114 10.9784 17.3586 4.51945 3.50834 +340 1 8.16823 5.15587 9.894 -28.9634 21.8059 19.126 +341 2 7.25961 5.26999 10.2972 28.5921 -4.04796 -11.5402 +342 2 8.23961 4.23455 9.67377 -1.01689 -19.4985 -4.69706 +343 1 1.66839 17.0027 18.4477 20.9596 26.331 -27.2012 +344 2 2.19503 17.5247 17.7665 -16.8758 -18.2972 22.1195 +345 2 1.83767 16.0826 18.2308 2.67698 -10.8321 1.22526 +346 1 1.40907 17.4029 15.3161 -1.8056 14.8407 8.29727 +347 2 1.4134 18.2156 15.8633 3.96238 -8.68525 -7.97287 +348 2 0.471831 17.1989 15.2085 1.34275 -7.61847 -1.46046 +349 1 3.49459 5.75594 6.06077 -10.0958 -15.2551 6.44531 +350 2 3.00844 6.4276 6.56158 3.56089 -0.0685925 -1.76679 +351 2 4.03572 6.19023 5.40706 10.0519 13.1926 -8.23224 +352 1 12.6765 9.5142 14.2706 -5.75697 27.7722 -14.2581 +353 2 13.0673 8.79775 13.7668 1.15853 -14.5514 3.26719 +354 2 12.382 9.20431 15.1249 -1.95515 -14.6959 8.85488 +355 1 4.11243 15.2112 7.12768 13.4261 4.57048 -4.21166 +356 2 3.68336 15.9917 6.77855 -13.243 7.84695 -2.74865 +357 2 5.05149 15.4218 6.9541 -4.34911 -9.58911 5.5273 +358 1 0.807347 8.85082 15.1137 12.1653 -16.291 -5.21716 +359 2 0.579225 9.7725 15.0704 -11.1033 15.5539 4.56692 +360 2 1.61112 8.83255 14.5724 -2.7466 -7.45742 -2.63208 +361 1 12.955 8.28126 10.1315 4.47425 -26.4789 2.77461 +362 2 13.6724 7.69661 9.75218 -12.3213 15.4477 18.6624 +363 2 12.7996 8.04439 11.0766 12.5165 -4.13221 -14.8671 +364 1 15.2413 7.99312 3.46307 21.2061 37.6089 -22.4299 +365 2 14.4756 7.7211 2.94477 -5.95544 -17.8301 8.14742 +366 2 15.6187 7.46858 4.17258 -15.9179 -18.0198 8.83427 +367 1 17.1356 6.70525 18.6386 6.47512 25.7091 -12.2215 +368 2 16.6963 5.89525 0.233999 -10.309 -8.75159 3.76643 +369 2 16.4339 7.33237 18.3357 11.2115 -13.3479 10.1501 +370 1 8.91981 7.02641 7.93476 -17.5815 -13.9195 9.00305 +371 2 9.83812 7.25537 7.853 19.0031 7.73693 -0.560136 +372 2 8.849 6.45385 8.72921 -1.20537 6.38433 -11.1549 +373 1 12.4784 0.471427 1.2 -1.5382 -11.3036 2.52426 +374 2 13.1724 0.955828 1.65737 6.96212 2.95671 -0.139484 +375 2 12.8855 0.124586 0.40059 -1.81614 4.12295 -0.743523 +376 1 5.7338 15.0104 14.483 3.21537 -3.99883 -6.81615 +377 2 4.79914 15.0689 14.6899 -13.3072 1.49299 3.3932 +378 2 6.00174 15.8892 14.196 3.10174 7.95604 -0.192962 +379 1 3.73322 6.46389 1.74186 4.97145 -11.2752 -15.478 +380 2 3.41061 7.27444 1.33141 -3.85483 5.16021 2.72417 +381 2 3.71896 6.61791 2.68352 1.01313 6.07651 8.98471 +382 1 3.85612 11.3357 12.3214 9.74989 2.64833 3.1782 +383 2 4.70398 11.747 12.5616 1.03181 -4.89631 -4.08494 +384 2 3.21292 11.8498 12.8111 -10.0411 9.11388 1.93155 +385 1 5.31882 3.86098 15.7247 -14.6622 43.9235 8.42988 +386 2 6.03513 3.29574 15.4808 24.4173 -17.8012 -3.50674 +387 2 5.69837 4.77513 15.8552 -8.87612 -28.0013 -6.19005 +388 1 14.0506 10.0984 4.70507 12.9021 5.9963 -48.2497 +389 2 14.373 9.82203 5.54065 6.42583 -15.3441 32.1568 +390 2 14.6577 9.66966 4.04903 -16.6446 6.96016 16.1133 +391 1 7.63016 17.2999 9.07082 4.88589 -1.83029 4.08955 +392 2 7.05774 17.6443 9.76408 -9.77236 -5.61109 0.722829 +393 2 7.90646 18.0745 8.58282 6.82018 7.73796 -12.3688 +394 1 4.54853 14.4989 3.92298 4.51049 -12.0827 -19.4455 +395 2 4.48676 15.3439 4.34231 1.7531 23.2793 6.06498 +396 2 4.47875 13.8474 4.61218 -0.893081 -14.6097 11.9436 +397 1 14.1162 7.44072 15.859 5.72353 -2.97717 1.52707 +398 2 14.8925 7.45204 15.2793 -3.03398 0.324075 5.79835 +399 2 14.4079 7.84098 16.6936 -1.38652 -1.7593 -3.67135 +400 1 2.91046 18.3824 1.92161 -14.6763 12.8451 -3.99897 +401 2 2.56811 17.7851 1.23066 -1.64793 1.84374 10.7046 +402 2 2.14175 0.293363 2.23042 22.3557 -16.8939 -8.97037 +403 1 8.00583 1.57089 4.46736 31.4122 8.97246 -10.4438 +404 2 7.40416 1.98491 3.8452 -8.42929 2.78546 -1.25861 +405 2 8.8818 1.75969 4.05638 -17.375 -7.71187 12.4181 +406 1 2.50572 14.1939 17.7606 -21.3738 -1.77578 0.320632 +407 2 1.88811 13.4733 18.0291 6.14349 16.4853 -5.08899 +408 2 3.36784 13.821 17.8832 22.941 -11.7322 7.4453 +409 1 0.984409 1.95477 13.9081 14.9076 0.866869 -10.4657 +410 2 1.09683 1.70126 14.8211 1.02253 -2.39927 14.2505 +411 2 18.6933 2.04344 13.7674 -16.8072 2.56857 -0.576968 +412 1 4.29327 0.177122 13.8951 16.4248 3.49785 -13.6548 +413 2 5.17049 18.4046 13.9646 -5.43827 4.9033 -2.01246 +414 2 3.78721 18.4389 14.598 -10.2443 -5.04864 16.3534 +415 1 7.35353 0.990853 18.4538 -34.7507 -7.39683 16.7648 +416 2 7.55815 0.737816 17.5561 -3.16307 -6.20953 -15.156 +417 2 6.35665 0.974064 18.6083 33.4978 7.02218 -7.3799 +418 1 15.8311 18.4256 13.8966 -40.0758 9.01377 -20.0242 +419 2 14.87 18.5763 13.7207 27.6408 -4.60797 -2.68704 +420 2 15.8417 18.2976 14.8321 10.6174 3.57585 21.6768 +421 1 10.2864 4.58419 16.2444 -24.4222 -37.2091 -9.88285 +422 2 11.2299 4.68793 16.3674 13.142 -4.29349 -1.09379 +423 2 10.1171 3.59079 16.124 8.18179 40.05 5.52806 +424 1 15.8917 17.7071 4.46459 -20.0388 -20.4222 2.09772 +425 2 16.4651 18.4471 4.57513 18.3163 24.2221 3.8588 +426 2 15.0409 18.0029 4.83395 4.42355 -1.752 -6.47073 +427 1 6.88773 17.6166 13.9821 -38.4037 0.167583 13.1844 +428 2 7.46394 17.6315 14.7417 15.8748 3.42447 12.5511 +429 2 7.41699 17.4009 13.2391 27.9809 -3.71977 -23.5355 +430 1 13.1764 6.43911 6.52144 -5.83912 -0.258919 -12.4557 +431 2 14.0695 6.77261 6.34605 -1.47407 -3.35023 -0.470203 +432 2 12.7466 6.3372 5.63472 11.513 2.45032 19.1456 +433 1 7.86196 2.29978 9.4638 -2.97627 -2.7765 -21.1046 +434 2 7.31086 2.09746 10.2267 -8.88065 1.6173 3.7395 +435 2 7.37564 1.98398 8.66115 7.69705 6.95472 18.2428 +436 1 15.1916 14.7366 13.8236 -12.2847 5.72199 -1.13466 +437 2 14.8954 15.0381 14.6996 2.36081 -1.57038 -3.3629 +438 2 14.579 15.1371 13.1848 7.3504 -2.29354 4.97967 +439 1 9.39483 8.42303 3.86324 -21.5436 -11.8424 -10.9865 +440 2 10.2164 8.84977 4.07537 16.3384 7.87643 5.27894 +441 2 9.57157 7.47345 3.83359 1.44741 0.673327 1.03302 +442 1 17.655 13.5671 16.4489 -7.58846 13.4511 -15.7424 +443 2 16.7203 13.3469 16.3992 -7.59268 -4.18946 5.70215 +444 2 17.688 14.4057 15.9472 10.2114 -8.11811 3.61388 +445 1 4.94979 10.486 2.86622 25.3355 -10.7625 -10.0508 +446 2 5.84023 10.0991 3.03563 -22.0316 6.96347 2.01482 +447 2 4.71704 10.9487 3.67532 0.603793 8.46932 2.75775 +448 1 3.68042 8.39717 9.8747 -7.87972 -17.3414 17.5888 +449 2 3.759 9.34077 9.71499 3.24219 9.53521 -0.886609 +450 2 3.55014 8.28216 10.8428 3.92085 5.02512 -16.6805 +451 1 15.9973 6.92061 5.87772 4.82031 -5.03924 3.59177 +452 2 16.6812 7.41263 6.34454 2.21588 0.961055 0.440265 +453 2 16.3186 6.0008 5.83915 -7.41322 12.2727 -5.03736 +454 1 15.3004 7.2666 8.94213 -32.1238 -12.1179 -31.7334 +455 2 15.9839 7.55437 9.51768 24.5834 17.5628 17.3411 +456 2 15.1488 7.91682 8.21973 7.72693 -8.10504 16.1569 +457 1 6.21705 12.8062 12.747 -22.7002 13.2796 -10.093 +458 2 7.05571 12.494 13.0465 21.6431 -16.5072 9.89045 +459 2 6.01919 13.5682 13.3077 2.09027 1.41895 1.21426 +460 1 12.1299 4.57596 13.1432 22.4432 17.9492 20.1123 +461 2 12.1793 4.58175 14.1216 4.56317 3.76233 -12.2652 +462 2 11.3861 4.04706 12.9369 -26.6961 -18.2025 -7.73732 +463 1 11.4375 8.07047 7.90979 27.6542 -15.5792 16.7856 +464 2 12.1952 7.52933 7.56059 -23.0528 10.899 -6.13628 +465 2 11.6627 8.11033 8.86659 -7.72222 6.32108 -19.0792 +466 1 16.9453 10.7968 7.63148 -3.5821 -10.5143 21.6719 +467 2 17.6495 10.1525 7.46889 2.86773 -0.504685 -4.5375 +468 2 16.8108 11.3218 6.85057 1.29813 10.4979 -20.4226 +469 1 5.19425 18.0282 10.6847 0.056878 3.62778 8.77145 +470 2 4.66571 17.4143 11.2104 4.95394 3.09506 -2.12913 +471 2 4.57063 18.3664 10.0251 3.33377 -5.62986 -0.929046 +472 1 7.60987 17.4226 1.56636 -8.76834 11.2024 10.6057 +473 2 8.12097 16.6429 1.35059 3.07922 -5.96866 -14.3061 +474 2 7.62904 18.066 0.842261 4.5937 -2.56699 -0.219584 +475 1 1.93734 12.9421 13.6328 4.51097 2.01356 -10.2989 +476 2 1.33249 12.4003 14.1383 -4.04092 -5.16916 8.28012 +477 2 2.1441 13.7105 14.1828 3.43289 -0.0153047 1.69165 +478 1 9.36109 6.77295 14.8254 28.0404 -16.4025 -23.0383 +479 2 9.79586 5.92856 15.0909 -10.7826 13.1246 6.51236 +480 2 9.73683 6.91972 13.9197 -17.1545 2.79671 17.5547 +481 1 15.2759 4.38629 10.7467 0.911226 -10.0818 1.35121 +482 2 16.2063 4.08729 10.7712 -9.28003 7.88291 1.38983 +483 2 15.15 4.95989 11.5268 6.34994 -5.62458 -10.0329 +484 1 11.4488 6.21672 0.0274361 8.35139 15.4334 1.07365 +485 2 11.547 5.26836 -0.0918922 -6.12153 -5.65013 -4.62095 +486 2 10.5221 6.46299 18.5238 -1.7877 -10.3718 -2.04901 +487 1 18.4903 11.4194 14.9121 8.77287 -18.4144 -27.074 +488 2 18.1021 11.8559 14.1353 -5.2902 0.217957 4.39134 +489 2 18.3331 12.0271 15.6113 -5.23497 22.6985 22.6894 +490 1 7.12593 9.28496 7.31024 -23.9992 -6.07508 6.39318 +491 2 6.74279 8.45494 7.66169 4.89732 10.9664 -5.80838 +492 2 8.06011 9.1434 7.29118 23.2007 -3.69072 -2.70719 +493 1 18.3302 15.3588 12.1663 1.84912 0.0598217 5.47138 +494 2 0.628985 15.4631 11.9685 -1.01298 4.74778 -2.81479 +495 2 17.8359 15.8974 11.5264 -1.18931 -3.22386 -0.556154 +496 1 16.5345 4.36456 5.22425 -62.6276 -15.6665 42.2949 +497 2 16.4135 4.0372 6.15475 14.4043 4.47956 -24.0603 +498 2 17.4334 4.499 5.03806 48.2264 1.34274 -11.6623 +499 1 17.733 3.12037 10.7685 2.78093 13.2032 15.2159 +500 2 18.62 3.27348 11.1411 -3.87004 4.46435 -8.2182 +501 2 17.7411 2.21797 10.4818 -1.03268 -21.1847 -12.2715 +502 1 12.2988 18.6545 10.1426 21.4258 -12.4002 -10.8053 +503 2 11.5002 0.459945 10.3706 -28.4452 4.23152 6.39845 +504 2 12.9389 0.72089 10.1511 12.8533 4.08749 0.539844 +505 1 10.4313 9.72872 12.541 3.98701 -3.38274 8.58973 +506 2 11.1703 9.84044 13.1623 -1.01011 3.74187 -3.45859 +507 2 10.4039 8.77038 12.4204 -3.66163 0.188688 -4.07709 +508 1 0.615048 2.63664 7.2276 -9.26807 24.3162 -18.5585 +509 2 0.353188 3.56967 7.37092 2.19049 -16.4853 1.00686 +510 2 0.949026 2.32684 8.06684 4.15829 -4.72879 9.31366 +511 1 0.333537 15.2707 6.93805 -1.63763 -14.4268 -44.2284 +512 2 0.559673 15.3175 7.85021 9.94673 -3.51892 30.6084 +513 2 0.629693 14.3791 6.62643 -7.55161 17.6489 9.10591 +514 1 17.0527 6.91364 14.9743 11.0217 0.359412 -1.38417 +515 2 17.7989 7.54943 14.9113 -7.11537 -10.2599 3.19545 +516 2 17.3979 6.08953 15.3732 -1.90278 10.2985 -1.25317 +517 1 9.14167 12.5321 7.98456 -51.8007 8.58975 -7.36144 +518 2 9.48882 11.7504 7.57305 13.8522 -18.8219 -15.7166 +519 2 8.22261 12.6161 7.58551 34.0094 -0.937982 16.6367 +520 1 1.15656 1.63828 2.76743 -9.76481 2.77041 -4.10292 +521 2 0.864287 2.18836 2.03128 -7.19413 -5.97378 -5.55322 +522 2 1.70002 2.22125 3.28253 11.7483 7.29404 14.7886 +523 1 4.17339 15.1305 9.84913 -14.3711 5.0779 2.99988 +524 2 3.91961 15.3463 8.93389 10.9385 -4.50851 5.90843 +525 2 5.03476 14.6902 9.78793 -0.575875 2.49321 0.528438 +526 1 7.3951 2.27992 14.8377 -1.12966 16.8522 -8.99686 +527 2 7.16414 1.54106 14.2639 1.26623 0.276941 -0.531744 +528 2 7.65338 3.03331 14.2573 -5.05472 -19.0282 8.30824 +529 1 18.3172 14.5403 2.1483 15.3986 5.40572 3.08201 +530 2 0.535799 14.8642 2.50804 -16.0996 -1.12956 -11.071 +531 2 17.7238 15.3001 1.99479 6.48993 -0.927096 4.3539 +532 1 10.0475 2.68059 12.9077 -3.02015 -13.9614 -15.6621 +533 2 9.89167 2.00033 12.2018 7.6523 15.7956 13.7679 +534 2 9.26985 3.25658 12.875 1.66072 1.15674 0.355625 +535 1 2.93978 8.85687 13.107 17.7725 7.3386 -7.69378 +536 2 3.37522 9.71823 12.8547 -12.3312 -24.1388 6.15133 +537 2 3.67473 8.22279 13.2377 -8.38529 8.44125 1.12687 +538 1 3.27106 8.61507 3.79074 -8.49716 -38.7584 59.7131 +539 2 3.66196 9.22584 3.22278 26.3747 36.1018 -32.8858 +540 2 3.70281 8.77413 4.67945 -18.9434 -3.96308 -29.2422 +541 1 5.92777 7.2521 8.64891 -10.8881 -6.62505 3.42768 +542 2 5.84919 6.30478 8.465 1.79189 -1.90292 -1.42585 +543 2 5.07694 7.48175 9.0605 5.83384 2.94932 1.14829 +544 1 14.8827 1.64134 1.82872 -12.6885 -28.1567 -9.76357 +545 2 15.1087 2.39997 2.36476 0.314968 13.4446 -1.58597 +546 2 15.1034 1.73075 0.884031 8.80659 10.9019 15.543 +547 1 8.66156 14.9913 0.655877 15.6167 -4.79217 23.7466 +548 2 9.42437 14.9505 1.28455 -14.0351 0.988592 -13.753 +549 2 7.99981 14.403 1.0655 -3.22335 6.28365 -6.24421 +550 1 15.4067 1.46647 7.20695 -8.82589 -12.8718 -0.882757 +551 2 14.775 0.932663 6.69065 9.74374 4.52972 3.50353 +552 2 14.8641 2.16562 7.57814 -1.0399 11.0322 0.525673 +553 1 4.92475 12.8978 18.4559 2.19674 -3.23744 10.1082 +554 2 5.23586 12.8997 0.738081 -1.33722 2.66651 -10.6279 +555 2 5.70033 13.1343 17.9365 -0.0827318 6.23371 -0.0935372 +556 1 15.3819 8.68528 18.0932 8.72121 10.5448 -14.8557 +557 2 15.8142 9.23534 17.405 -7.78496 -12.8196 8.73029 +558 2 15.2566 9.31777 0.164984 -6.85428 -0.586954 10.5179 +559 1 12.0126 3.13082 18.276 9.47145 -1.72319 12.159 +560 2 12.2482 3.16999 0.564179 -5.55591 0.644277 0.165862 +561 2 12.5655 2.41012 17.9461 -5.90061 -0.236568 -11.7395 +562 1 13.2006 12.6959 5.14014 6.0546 -4.02499 4.06103 +563 2 13.6294 11.8271 5.0147 -6.69767 7.2237 -2.15456 +564 2 13.3727 12.9234 6.07289 -1.67526 -4.52376 -7.3865 +565 1 6.1651 7.14436 0.195504 -22.0894 -12.2339 1.18179 +566 2 6.12052 8.09409 18.9477 10.183 13.9972 -1.43251 +567 2 5.2591 6.87987 0.448218 12.567 -4.05161 -1.41715 +568 1 17.6881 15.878 14.8655 -1.85909 5.77814 22.6605 +569 2 16.7739 16.1608 15.0761 11.3822 -6.39517 -19.8211 +570 2 17.8371 15.675 13.9293 -11.1648 4.64831 -4.02463 +571 1 13.1067 0.88062 16.8301 -1.16362 5.09418 6.26073 +572 2 14.0188 0.56665 16.8428 4.80395 1.33473 -1.08149 +573 2 12.5822 18.7235 16.7479 -0.784604 -6.20947 -5.79489 +574 1 10.8701 14.5014 7.48366 30.6398 4.5327 -13.288 +575 2 10.1924 13.8927 7.76637 -8.27046 -6.89901 6.40521 +576 2 11.688 13.9665 7.40985 -13.0568 5.23738 5.47236 +577 1 17.7216 8.3975 2.13341 -5.03714 18.392 15.6468 +578 2 16.8261 8.35978 2.51012 1.26608 -2.81583 -3.60077 +579 2 17.7343 7.78208 1.41002 -5.68948 -14.3091 -15.2975 +580 1 12.4651 7.83121 2.02849 6.21002 21.8293 -0.701234 +581 2 12.2371 8.77742 1.88873 1.61752 -16.1639 -0.0618129 +582 2 12.1801 7.35781 1.23988 -4.06145 -2.69746 -4.32972 +583 1 11.9912 14.5504 10.3779 26.255 2.08103 -27.6641 +584 2 12.3772 14.5828 9.46952 -12.6474 -4.22617 24.8662 +585 2 11.0517 14.669 10.2537 -15.8484 3.20565 2.09431 +586 1 6.76727 6.87556 15.5462 0.393734 11.8444 22.477 +587 2 7.69535 7.12306 15.3658 -7.56189 -7.86407 -0.973014 +588 2 6.54154 7.32616 16.388 3.13619 -10.9433 -13.6985 +589 1 7.93405 4.43454 13.181 3.70457 37.9343 33.3332 +590 2 7.23909 4.66367 12.5613 -7.79541 1.00974 -8.53955 +591 2 7.95717 5.24214 13.788 5.6586 -32.0049 -23.1645 +592 1 13.3208 12.2124 14.3278 -1.85908 1.78375 8.34338 +593 2 13.1627 11.2597 14.246 -0.36998 0.633125 0.823702 +594 2 13.6236 12.4909 13.4584 3.579 0.31603 -3.71376 +595 1 14.5678 9.48203 7.30395 8.22624 -5.55489 -6.16459 +596 2 15.3274 10.0218 7.53849 6.73854 1.05081 2.13221 +597 2 13.8344 9.86252 7.77014 -14.2105 5.15772 9.40205 +598 1 12.6689 16.8584 3.2838 3.32354 22.4122 -6.02395 +599 2 12.8251 17.4603 4.02708 -0.185303 -8.85949 -0.0347213 +600 2 12.7374 17.4469 2.50984 -1.71014 -6.46341 4.85536 +601 1 0.984375 7.0735 17.3432 34.0501 -3.91376 2.11413 +602 2 0.125246 6.96907 17.7347 -25.3968 2.18392 3.09576 +603 2 0.950307 7.67775 16.5933 -9.77339 5.8232 -4.41721 +604 1 13.0022 4.84407 15.777 5.081 -10.3329 -5.56354 +605 2 13.7485 4.25418 15.5901 -10.0146 -2.33354 7.04552 +606 2 13.4521 5.67804 15.8535 -1.12386 24.7122 1.66863 +607 1 2.36131 3.40053 5.10919 -9.6311 -14.0051 -9.38531 +608 2 1.85776 3.14724 5.88615 -5.89279 -11.6191 4.05299 +609 2 2.64546 4.27356 5.34111 14.5219 19.3293 2.74972 +610 1 8.16093 10.9198 13.7208 -5.48668 -10.5203 36.1407 +611 2 8.01338 10.5218 14.6488 11.4544 18.6016 -43.3573 +612 2 8.9553 10.5154 13.3405 3.89898 -1.19123 3.66799 +613 1 13.0685 1.50992 13.279 -14.1832 25.7313 -25.8855 +614 2 13.6244 1.50815 12.4613 -6.9447 -4.36872 19.5281 +615 2 12.4297 2.25673 13.1075 20.3356 -25.0236 11.2619 +616 1 6.62047 13.6375 2.07221 -5.18984 1.0977 1.00923 +617 2 6.01355 14.0796 2.67998 -4.17105 4.32933 -3.39809 +618 2 7.10668 13.0566 2.65885 8.90022 -6.51269 2.26225 +619 1 15.8066 6.3469 12.5124 13.7748 11.2213 20.1038 +620 2 16.2844 6.87459 11.8544 0.57451 -1.64399 2.92177 +621 2 16.2805 6.52872 13.3684 -12.0243 -5.9969 -18.7155 +622 1 16.7622 0.649503 9.5351 11.3629 -0.534141 16.2257 +623 2 16.8233 18.3334 9.63984 -7.20854 -2.096 2.62458 +624 2 16.3504 0.825019 8.69009 -8.20455 0.909068 -17.3039 +625 1 6.16155 11.6721 8.23727 11.0478 -14.7079 4.32064 +626 2 5.37204 11.4355 8.7099 -18.5694 3.37101 8.66714 +627 2 6.52549 10.7898 8.06052 6.85938 7.24602 -7.48704 +628 1 2.80718 8.60686 0.397493 -27.1124 -12.7057 -15.0387 +629 2 2.16203 8.12721 18.4284 20.3601 19.9434 23.0266 +630 2 2.28863 9.2379 0.937046 1.66532 -5.5958 -10.4069 +631 1 10.1061 10.2794 6.574 -2.68384 6.39054 8.98367 +632 2 10.587 9.61275 7.07222 2.60765 -6.52577 4.24337 +633 2 10.6348 10.4062 5.77746 -5.53346 0.236498 -3.27199 +634 1 6.84319 15.7735 6.74802 2.92919 -7.52667 3.13791 +635 2 7.22287 16.2754 7.48672 -6.2609 -2.86584 0.474311 +636 2 7.16745 16.2182 5.95944 -1.73758 9.59963 -7.48558 +637 1 6.59004 12.8453 5.92771 5.9232 5.70246 -10.7633 +638 2 6.81648 13.7523 6.14266 -3.08056 9.02497 3.95142 +639 2 6.18071 12.4806 6.71128 -2.95494 -1.85994 5.08984 +640 1 16.7187 12.5557 9.81602 -6.97981 -8.42056 3.44329 +641 2 16.7367 11.9049 9.10465 3.04519 -4.31121 0.702836 +642 2 17.0063 13.3635 9.40922 2.88649 12.8114 -1.84814 +643 1 6.30344 2.78963 2.73877 -9.04367 -13.9111 -2.70816 +644 2 6.4136 3.72217 2.50807 2.58545 1.58307 -3.30667 +645 2 5.8765 2.3355 1.98292 3.38351 11.0448 5.4768 +646 1 10.696 2.92954 3.25253 -4.78239 0.546409 -3.48797 +647 2 10.285 3.77274 3.47459 -3.26512 -0.523652 -3.33277 +648 2 10.2907 2.61783 2.41902 1.90367 1.74508 6.25714 +ITEM: TIMESTEP +100 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.7952 6.55188 17.82 -14.0925 -19.7636 -3.75378 +2 2 7.88023 6.44026 18.1695 19.5523 6.07432 -5.80163 +3 2 8.99571 5.7855 17.2401 -2.64216 11.7935 9.74201 +4 1 0.13387 8.39658 6.71777 11.0686 -17.0219 51.8315 +5 2 0.297964 8.15416 5.82611 3.65759 -8.78146 -34.4276 +6 2 0.663997 7.73523 7.26654 -21.1289 27.238 -19.6589 +7 1 8.71966 0.469223 7.04147 6.63626 1.40123 -3.67752 +8 2 9.62406 0.435013 6.6778 -11.0722 1.83914 2.93454 +9 2 8.2146 0.970711 6.38506 4.19741 -2.20649 2.49068 +10 1 6.44826 1.6863 11.7796 22.1018 -16.0737 -10.0998 +11 2 5.81214 2.23354 12.2013 -20.9633 15.3476 12.0772 +12 2 6.02072 0.836228 11.6256 -4.8988 -3.15305 -3.34718 +13 1 6.89097 5.45035 2.38694 -14.0878 18.1315 0.804401 +14 2 6.23022 6.01625 2.92115 27.2653 -21.4077 -23.7527 +15 2 6.91491 5.77412 1.45583 -9.40281 2.39732 25.4334 +16 1 16.2334 10.2315 16.0664 1.22095 -12.8583 -8.35396 +17 2 17.1105 10.2758 15.679 0.521344 2.88453 0.293596 +18 2 15.9464 11.1361 16.1778 -3.48259 10.2735 3.78324 +19 1 10.8573 15.0007 2.35193 -8.17785 -20.274 -7.01899 +20 2 10.8024 14.5151 3.19219 -3.98998 0.859093 -1.88791 +21 2 11.3201 15.8014 2.5578 8.92048 16.4226 10.3474 +22 1 17.1726 8.21805 11.024 14.0848 -19.0512 -23.2094 +23 2 16.691 8.91369 11.4632 -8.36385 12.6057 9.94503 +24 2 17.8921 8.64427 10.518 -5.71892 -0.131476 8.97419 +25 1 14.5956 15.9799 16.3132 20.7515 -13.8502 3.42179 +26 2 13.7469 16.3872 16.1713 -21.6627 3.23661 7.28294 +27 2 14.5521 15.3865 17.0935 -1.40849 8.21009 -3.21798 +28 1 12.1509 13.2395 0.573493 6.57205 3.5904 2.72349 +29 2 11.837 13.3986 18.3303 -3.80405 -1.74926 -15.723 +30 2 11.7012 13.9105 1.09717 -2.12612 0.929616 9.94365 +31 1 9.32377 5.48511 3.80515 37.2224 0.919853 24.8976 +32 2 8.88878 5.295 4.65312 -11.8166 2.00864 -7.28102 +33 2 8.70235 5.44743 3.10202 -35.0307 -2.6733 -15.0358 +34 1 1.53449 3.88906 11.5762 -21.4592 42.8438 -26.3691 +35 2 1.39761 4.77552 11.9865 7.05639 -9.88004 -9.22537 +36 2 1.89707 3.34621 12.2331 21.1403 -27.4328 37.6181 +37 1 2.11621 6.94729 8.0812 -5.52003 -16.2776 -1.04121 +38 2 2.5746 7.45442 8.7366 8.45236 15.6822 11.2536 +39 2 2.08388 6.07661 8.50513 -4.57751 -6.44388 -7.47435 +40 1 5.24695 4.43578 7.8028 -6.30612 26.2857 -2.69952 +41 2 5.36677 3.49844 7.65426 0.215716 -12.5366 -1.65761 +42 2 4.56392 4.76953 7.18377 10.1949 -9.65667 2.91339 +43 1 3.43524 2.88686 17.4376 -21.7675 5.87472 14.6558 +44 2 3.90981 3.17382 16.6701 17.8952 10.4272 -14.0542 +45 2 2.87759 3.6541 17.6984 8.18662 -9.04753 2.1829 +46 1 7.55778 5.57378 6.15352 3.99821 9.40639 19.9011 +47 2 8.12518 6.20749 6.66299 -12.9927 -14.0765 -9.88952 +48 2 6.98227 5.15891 6.82729 7.75312 -1.10557 -10.9113 +49 1 9.77611 7.00478 12.0482 -6.90333 -2.64414 -8.04886 +50 2 10.0224 6.11753 11.7611 0.642082 2.81741 -0.891425 +51 2 9.0843 7.2891 11.4183 2.80801 -0.947675 5.79882 +52 1 14.1423 3.90191 8.16294 -23.6925 4.35767 -24.2753 +53 2 13.5235 4.53411 7.72337 18.2577 -11.8103 7.89417 +54 2 14.4024 4.31063 8.97869 6.95814 7.70003 16.5888 +55 1 4.54437 17.2359 3.8519 4.03565 10.1791 3.31349 +56 2 5.34213 17.7268 4.08304 4.36901 -6.62302 -0.267376 +57 2 4.17051 17.7127 3.09453 -6.96766 -2.87365 4.53203 +58 1 16.1339 16.4921 10.5971 24.4543 -12.0388 -34.7313 +59 2 15.4578 16.6815 11.2098 -23.1752 5.77424 26.3474 +60 2 15.6745 15.9439 9.92709 9.81353 9.26167 7.23238 +61 1 1.98282 4.87023 -0.0102057 11.328 -31.2723 15.691 +62 2 2.56866 5.25094 0.666382 -3.10152 5.14206 -1.69339 +63 2 1.65849 5.5885 18.1127 -8.58794 22.0564 -11.6074 +64 1 11.0975 13.3336 16.4568 21.334 -26.4555 -13.6253 +65 2 10.7319 12.43 16.5661 -7.83355 14.7592 4.38577 +66 2 11.7328 13.1734 15.7328 -3.59268 8.82171 6.12988 +67 1 9.983 10.9188 16.8195 21.8027 -17.9597 14.5818 +68 2 10.5015 10.1139 17.0687 -12.258 16.9146 -11.8156 +69 2 9.08607 10.6082 16.6912 -8.94921 1.38614 -3.26281 +70 1 11.9148 17.5563 13.4787 -11.9158 -12.5975 -1.23623 +71 2 12.5676 17.2101 12.8515 -0.0246338 2.67811 4.16536 +72 2 12.0003 18.5089 13.4756 8.75914 10.3848 -3.31648 +73 1 6.43245 9.54572 12.2957 1.63429 -3.34072 -14.2423 +74 2 7.08046 9.15867 11.6656 -10.0512 7.63496 6.98562 +75 2 6.90317 10.1892 12.8448 2.76093 -9.73394 -7.4892 +76 1 16.2985 12.7819 2.78073 -6.76278 9.02259 -0.251856 +77 2 17.1507 13.1937 2.56739 -3.11425 -2.92719 1.79117 +78 2 15.6658 13.5347 2.78258 7.1706 -12.5209 -0.796151 +79 1 0.705375 12.7757 5.80641 -31.4327 0.785322 -26.0818 +80 2 0.964058 12.7408 4.86595 9.86444 -3.28161 8.94612 +81 2 18.3663 12.6813 5.72517 19.7421 -2.33124 11.5636 +82 1 5.30386 16.3127 18.466 5.80758 -1.43031 -6.37222 +83 2 5.80257 15.6526 17.9366 -5.42534 13.184 13.7491 +84 2 5.92544 16.7092 0.45256 -3.43112 -6.46136 -2.11967 +85 1 0.781035 7.63768 4.09742 11.023 -5.93732 13.9838 +86 2 0.258202 7.96457 3.37539 -14.755 3.95315 -10.1558 +87 2 1.66078 7.97253 3.8829 3.26007 -0.00880383 4.41534 +88 1 3.24417 9.16605 6.56429 -20.4701 -14.3326 2.83801 +89 2 3.57159 8.65908 7.31953 1.49107 7.58135 -6.52778 +90 2 2.30098 8.88971 6.4655 20.5558 12.7829 2.43715 +91 1 7.26627 10.4004 16.2591 -15.7562 -6.32656 27.9079 +92 2 6.82075 11.2368 16.4586 5.73239 -2.42146 -6.93429 +93 2 6.93167 9.82605 16.9811 6.22417 8.86745 -10.8084 +94 1 10.9892 0.849679 5.07849 4.12027 -5.76689 -13.93 +95 2 11.0513 1.64213 4.53259 0.725375 9.02843 9.39609 +96 2 10.6504 0.238952 4.4041 -0.868918 -3.08012 11.6628 +97 1 4.18223 2.98976 13.1617 1.80285 -9.79496 -4.9743 +98 2 4.46754 3.28562 14.0477 -4.0491 -7.36491 -7.89898 +99 2 4.03841 2.01285 13.1683 3.67857 16.3758 11.7633 +100 1 8.4888 10.2856 1.85141 10.3375 -10.6918 -8.28538 +101 2 8.43451 10.9691 2.52904 -3.58901 -0.686288 7.94652 +102 2 8.82874 9.48425 2.29142 -6.1923 10.8646 1.43904 +103 1 10.2336 1.64305 15.4458 -13.2429 9.10796 4.38269 +104 2 11.1732 1.63861 15.572 16.9305 -2.55664 -1.17381 +105 2 10.0536 2.05804 14.5895 6.55462 -3.46994 -1.37038 +106 1 2.58993 12.7242 7.97336 -7.23425 -8.94691 3.8681 +107 2 3.01571 13.5704 7.82234 5.57764 5.06786 -6.45979 +108 2 1.98486 12.5774 7.23174 0.806159 4.05811 0.362671 +109 1 3.90685 11.8307 5.02738 -19.955 -7.05304 -0.3571 +110 2 3.70751 11.1281 5.68153 3.09094 12.242 -8.4391 +111 2 3.06715 12.0092 4.53628 19.8771 -7.15241 7.2697 +112 1 6.7679 14.5791 16.9276 2.77817 -6.983 11.0716 +113 2 7.71708 14.7379 16.9268 0.980214 1.28706 0.809355 +114 2 6.44853 14.8723 16.076 -0.709014 -5.22289 -12.1565 +115 1 14.1752 14.508 3.1348 7.33594 -12.7834 -7.22412 +116 2 13.6105 15.2801 3.10139 -3.55206 9.35654 4.80996 +117 2 13.7682 13.8754 3.73922 -4.33905 3.15851 6.00261 +118 1 8.77346 18.0937 16.1268 -49.3086 -19.2657 7.09896 +119 2 9.29148 17.2891 16.2682 10.0054 9.31596 -1.94744 +120 2 9.22615 0.228463 15.833 27.8858 8.66202 -5.29688 +121 1 4.63977 1.75161 4.89947 12.6555 12.3233 -26.7382 +122 2 3.82082 2.25711 4.97207 0.159842 -3.07614 2.23584 +123 2 5.05477 2.09313 4.05862 -7.26402 -10.6651 28.8422 +124 1 15.0293 12.6717 16.5117 -23.31 -0.861404 35.6256 +125 2 14.4426 12.7177 17.3057 24.815 2.28331 -11.4604 +126 2 14.393 12.496 15.8301 -9.60755 -0.359254 -28.8722 +127 1 15.7282 18.4115 16.8424 17.2085 30.6847 -2.58542 +128 2 16.585 18.5255 17.3163 -17.0651 -10.3906 -2.34083 +129 2 15.5073 17.4884 16.7844 1.64687 -19.4864 2.05956 +130 1 1.3653 1.32145 16.674 4.57571 12.7751 22.4809 +131 2 2.22966 1.72757 16.8986 -13.3853 -7.67206 -8.47788 +132 2 0.843747 1.53379 17.4789 2.23908 -6.3926 -16.4011 +133 1 18.2502 4.28823 15.9426 5.59379 -7.24598 -18.3859 +134 2 17.8025 3.49471 15.6029 3.53909 11.4984 4.55434 +135 2 0.380345 4.42598 15.3659 -10.3938 -1.91133 11.4 +136 1 12.0179 17.0993 16.1449 -24.7595 -29.8482 27.6473 +137 2 11.2904 16.5264 16.5371 30.7476 29.6052 -3.96723 +138 2 11.7854 17.0696 15.2267 4.30162 8.23296 -25.5613 +139 1 16.0455 2.77586 18.2041 10.6955 -6.31261 -1.53201 +140 2 15.9135 3.65525 18.5895 -10.0784 -5.09061 -10.2232 +141 2 15.7148 2.7749 17.2908 -2.70848 4.2718 2.75475 +142 1 6.57887 13.7167 10.0128 0.388305 24.4332 24.1101 +143 2 6.2636 13.3347 10.8463 6.37938 -3.40375 -0.55213 +144 2 6.43171 13.0818 9.3305 3.17506 -19.669 -12.997 +145 1 10.1062 18.565 2.71626 12.0596 2.32822 -17.6158 +146 2 10.7563 0.294125 2.0815 -9.9929 -7.47975 8.60443 +147 2 9.2984 18.4331 2.20633 -1.12272 -0.999648 5.59115 +148 1 3.10044 17.6571 6.21769 -0.590198 -1.20238 18.0356 +149 2 2.16339 17.7471 5.9649 14.558 -0.242179 -11.811 +150 2 3.6505 17.6877 5.42436 -8.00238 0.252249 -9.63341 +151 1 12.5899 16.7797 7.85568 11.434 -9.28582 -14.859 +152 2 11.8995 16.1049 7.73478 -4.76829 8.38316 1.604 +153 2 12.3367 17.3735 8.55676 -7.89443 8.69289 16.0625 +154 1 14.8958 15.3252 8.42405 -10.9907 16.0866 -10.412 +155 2 14.2257 15.9607 8.05927 9.60746 -16.915 15.6813 +156 2 15.568 15.2992 7.73812 1.83068 -0.846784 -8.90808 +157 1 17.9236 18.2959 0.16927 -20.6229 -20.5305 -14.2597 +158 2 18.7101 17.7336 18.8116 8.98564 4.8691 -3.01699 +159 2 18.0908 0.428516 0.675884 12.0916 17.8267 11.1415 +160 1 0.800533 10.4853 1.48213 -15.9305 -52.1134 32.1201 +161 2 0.0210499 9.87138 1.72712 35.348 27.3948 -12.4938 +162 2 0.488783 11.092 0.839839 -12.4886 25.7711 -24.5144 +163 1 1.85398 12.3107 3.26054 -2.39029 3.71051 2.5874 +164 2 1.61156 11.5651 2.68837 -2.80207 3.45241 0.205878 +165 2 2.01622 13.0664 2.66785 -2.08994 -5.59574 4.32216 +166 1 0.726068 17.2941 4.97534 23.1964 8.93599 -27.6283 +167 2 -0.00504426 17.9045 4.96895 -11.3657 3.83105 9.40925 +168 2 0.6848 16.6356 5.64734 -16.8394 -17.6158 22.5419 +169 1 0.979774 0.931094 9.39103 18.34 6.67236 9.68687 +170 2 1.13606 0.587208 10.3041 -6.25966 0.627701 -15.4141 +171 2 0.222638 0.493139 9.00427 -6.20505 -6.29115 6.11619 +172 1 16.8132 2.44689 13.4524 12.1018 18.2567 -5.29927 +173 2 16.9941 2.74318 12.5312 -5.60486 -9.11594 12.8952 +174 2 16.5475 1.52939 13.4414 -4.39811 -15.2301 -8.28386 +175 1 2.68823 16.0572 12.0971 4.35106 -7.5731 1.60029 +176 2 3.00862 15.6347 12.9147 -3.00711 3.68751 -12.4652 +177 2 3.25289 15.7623 11.3532 -3.53001 -2.50035 7.7005 +178 1 16.365 15.3972 6.07793 1.10786 -2.726 6.22736 +179 2 17.2616 15.5854 6.39959 0.338369 -3.43469 -2.74975 +180 2 16.1217 16.1306 5.49548 2.77772 2.55878 -2.13745 +181 1 5.71885 5.23685 11.7571 -1.38587 -22.0348 -7.59079 +182 2 5.34065 5.94353 12.2818 1.95161 11.9795 4.35233 +183 2 5.13977 4.47517 11.9216 1.17844 4.76848 -1.31072 +184 1 15.1029 4.9502 0.771222 1.99697 3.13949 16.3358 +185 2 15.0181 4.74755 1.72068 1.03511 -0.706475 -1.64751 +186 2 14.2572 5.32925 0.539529 -7.17443 2.24029 -6.36177 +187 1 16.4241 16.5209 1.77175 11.7834 22.2537 -31.9797 +188 2 16.1353 16.901 2.59837 -3.82757 4.70614 16.3909 +189 2 16.7243 17.3043 1.2165 -7.10171 -29.7856 17.5505 +190 1 0.166785 4.90105 4.02875 -9.807 6.14851 -6.2016 +191 2 0.490919 5.80972 4.19933 1.47178 -10.2493 -2.87817 +192 2 0.85797 4.25703 4.16889 13.481 4.94217 6.1798 +193 1 2.95388 15.1092 15.162 10.7369 -8.35154 -8.83455 +194 2 2.79081 14.8128 16.074 0.0767364 3.70074 1.09557 +195 2 2.55949 15.9866 15.0864 -8.26758 5.41964 7.36053 +196 1 1.08589 14.7081 9.5149 24.8711 -1.95174 9.92838 +197 2 2.02655 14.926 9.73253 -22.6422 -7.57261 -8.5802 +198 2 0.981604 13.769 9.74603 1.17561 7.47496 0.770389 +199 1 13.5787 16.5188 11.5692 -12.2314 13.2219 -8.78769 +200 2 13.3397 17.246 10.9551 -0.181138 -8.24863 9.65793 +201 2 12.9892 15.7954 11.3146 2.83531 -7.80051 -5.41791 +202 1 4.81777 1.55092 0.678258 -26.6156 -3.92273 4.29753 +203 2 4.35705 2.21925 0.160828 3.99581 1.83661 -5.90848 +204 2 4.05187 1.04139 1.04246 22.8613 -3.7169 0.169547 +205 1 1.54475 18.6679 11.892 -7.41525 16.2224 7.56704 +206 2 1.47416 0.586534 12.6867 1.33096 -5.97454 -6.01551 +207 2 1.79005 17.7987 12.209 7.72027 -7.46968 0.191542 +208 1 11.4358 10.1471 4.23265 -10.894 -3.87129 -8.35951 +209 2 11.2613 10.4034 3.31126 9.28636 4.56211 3.82985 +210 2 12.3915 10.0236 4.32197 -4.85978 3.43988 -0.432274 +211 1 8.20336 12.1359 3.88849 -13.0458 16.1374 35.7669 +212 2 8.99874 12.5954 4.16275 16.0075 -1.33649 -14.8839 +213 2 7.69556 12.2697 4.73273 -2.96338 -15.3566 -29.2591 +214 1 14.5957 4.06338 3.37559 11.9385 -4.24509 -11.5663 +215 2 15.1907 4.01381 4.14053 1.35901 4.80596 -1.61984 +216 2 13.7786 4.41816 3.71066 -15.4173 6.10577 6.17301 +217 1 5.71905 1.6749 7.61995 8.80947 6.26404 67.7498 +218 2 5.099 1.08549 8.07836 1.13728 7.44943 0.131268 +219 2 5.55556 1.51371 6.73852 -13.1925 -8.9768 -74.4163 +220 1 17.8986 1.04478 4.82737 2.1754 -1.83476 -0.744307 +221 2 18.4917 1.14925 4.06283 -1.19754 2.46044 8.41233 +222 2 18.3052 1.49477 5.5864 -1.29774 -0.0865267 -3.68542 +223 1 6.84138 9.15652 4.5536 4.1666 1.31036 -3.45285 +224 2 6.90548 9.53593 5.43168 -5.85674 1.32054 6.56912 +225 2 7.76285 8.95875 4.34348 -1.51129 -0.833856 -3.18299 +226 1 2.51554 14.7147 2.08788 -0.0450507 -1.43316 -6.26715 +227 2 3.18184 14.7861 2.78103 3.7873 -1.55841 0.251503 +228 2 3.00277 14.5163 1.27395 -5.30581 6.45149 3.77223 +229 1 17.2192 13.0031 13.0554 -12.0926 -3.19634 4.57291 +230 2 16.3553 13.3969 13.3572 27.3304 0.34804 -8.60607 +231 2 17.7786 13.6982 12.6582 -16.3476 4.90844 7.68697 +232 1 14.8182 10.5634 1.61386 4.26778 13.3748 6.0388 +233 2 15.4677 11.1895 1.9919 -6.32062 -5.48184 -5.48699 +234 2 13.979 11.0422 1.62876 3.88819 -6.35193 -1.63244 +235 1 5.61579 6.74404 4.50101 -16.4591 -25.6922 -2.42498 +236 2 5.98931 7.61359 4.54862 8.72135 21.7956 -0.434523 +237 2 6.18395 6.1944 5.05334 5.89398 3.69136 0.98365 +238 1 7.99723 8.25195 10.2692 14.8304 8.84149 10.0706 +239 2 8.65992 8.88256 9.91656 -9.90097 -8.80766 -1.78449 +240 2 7.59566 7.7759 9.52484 -1.48617 9.19501 4.49734 +241 1 13.4628 18.4324 5.71378 17.6235 1.75148 -9.47684 +242 2 12.708 0.350866 5.56458 -19.7852 7.87128 -2.36248 +243 2 13.2811 17.9777 6.53219 -7.30606 -12.1428 7.93723 +244 1 0.0668655 2.55772 0.44163 -1.64079 -15.5797 1.12414 +245 2 17.7792 2.62308 0.158326 7.01821 10.3157 -4.2768 +246 2 0.560589 3.37114 0.261458 -5.35649 7.7487 -2.70304 +247 1 12.8473 10.8167 9.6749 -29.1069 48.3462 -20.1155 +248 2 11.856 10.995 9.62541 32.1605 -20.6147 5.13184 +249 2 13.0142 9.92242 9.94244 -8.5776 -22.9331 5.75343 +250 1 0.607197 12.3488 11.1216 10.7177 -2.21067 3.69277 +251 2 18.3016 12.4338 11.1296 -15.0263 -0.672926 -5.71109 +252 2 0.887353 12.7089 11.9725 7.71276 -2.01358 -2.19338 +253 1 5.32001 7.36668 13.2938 5.32433 15.1635 7.63099 +254 2 5.70557 8.20602 12.9842 -2.91102 -7.98825 -6.07053 +255 2 5.82609 7.21997 14.1065 -9.96591 -5.08448 1.55341 +256 1 1.1733 6.74916 11.943 -30.749 -23.7015 -12.6924 +257 2 0.265139 7.01822 11.7017 14.0517 -0.957096 2.97943 +258 2 1.61086 7.53614 12.2133 15.6557 23.6476 13.031 +259 1 15.5486 9.75906 12.4999 -0.653644 29.4777 3.96245 +260 2 15.1521 10.5891 12.1135 7.41979 -25.1975 16.8694 +261 2 15.9641 10.0301 13.3422 -9.48671 -5.05259 -12.6364 +262 1 16.5044 12.5382 5.51299 -3.50049 1.7151 -41.7779 +263 2 16.2902 13.4721 5.54585 0.30498 11.7411 21.1442 +264 2 16.3754 12.4207 4.53497 7.77761 -11.637 24.1999 +265 1 6.32544 9.92844 0.21289 -23.4091 -5.64021 -11.1485 +266 2 5.58447 10.3552 0.689761 9.59747 -6.57127 -5.34636 +267 2 7.10511 10.1371 0.71679 14.7949 3.34633 14.2781 +268 1 12.1134 5.97718 4.01208 -22.8865 -14.7559 9.656 +269 2 12.2541 6.73773 3.46345 4.76282 13.7738 -16.8186 +270 2 11.1454 5.80116 3.92348 22.2207 -1.187 3.16864 +271 1 0.310021 12.9061 0.00438974 -4.95288 1.79463 -7.14095 +272 2 18.578 13.473 0.695812 6.768 -1.51286 0.947724 +273 2 18.4929 13.1888 17.8371 0.864006 -6.25549 9.7975 +274 1 3.57649 0.0893425 8.67318 10.7138 1.44606 -23.5182 +275 2 3.53585 18.3471 7.78602 0.204258 -6.73647 -0.0210952 +276 2 2.75019 0.556646 8.71194 -17.5671 6.50862 13.0872 +277 1 7.32229 17.553 4.46711 -1.8346 22.7033 -6.51397 +278 2 7.49747 18.5341 4.60164 1.92735 -36.6431 -12.1684 +279 2 7.43093 17.3591 3.50845 0.44318 8.65947 16.4016 +280 1 9.23372 17.1692 12.2368 -1.40541 18.7929 10.7586 +281 2 9.17923 16.5713 11.4947 6.54031 -16.824 -6.24154 +282 2 10.1445 17.1937 12.5849 -6.50468 -4.83213 -2.69749 +283 1 13.3883 13.1392 7.89062 -8.44361 -29.718 12.0449 +284 2 13.2983 12.3346 8.48336 5.26587 25.8846 -16.8323 +285 2 14.1176 13.673 8.22732 -1.02664 3.48474 5.19869 +286 1 14.8313 2.83639 15.4549 13.5448 -0.0778016 6.35676 +287 2 14.1767 2.18003 15.2177 -4.87233 -8.03631 -4.89691 +288 2 15.4971 2.82305 14.7488 -5.52573 3.83225 -1.21536 +289 1 9.88985 15.6498 16.9162 -1.5178 12.6863 -12.8881 +290 2 10.4068 14.8878 16.6522 -4.3383 -15.6303 0.424585 +291 2 9.57752 15.4658 17.7984 -6.29913 -5.39682 13.2163 +292 1 11.1832 8.45041 16.604 0.69795 7.62392 -5.91094 +293 2 10.4558 7.91494 16.2714 -2.08228 -2.22425 -3.83894 +294 2 11.7364 7.86183 17.1086 3.16052 -9.92137 8.33691 +295 1 3.98058 18.2281 16.8796 4.69725 -6.17709 8.80305 +296 2 4.47544 17.5796 17.4031 -3.04366 -6.21568 -3.2578 +297 2 4.2975 0.415113 17.2284 -3.71051 8.24157 -1.82763 +298 1 2.31186 4.29334 8.90298 15.9673 -19.5394 32.2139 +299 2 3.25638 4.01729 8.88792 -18.4415 10.5974 -6.3491 +300 2 2.00846 3.99585 9.80326 5.50039 13.6474 -24.2252 +301 1 9.93626 10.4071 9.85717 -7.16433 6.26663 -15.7674 +302 2 9.36967 11.1624 9.60099 8.89086 -7.49456 6.1891 +303 2 10.0442 10.3828 10.8072 -0.648607 3.91668 13.0823 +304 1 9.8312 0.910661 10.8223 11.6198 7.73817 -5.63486 +305 2 9.46664 0.0599513 11.0613 -12.5627 -8.03565 7.40448 +306 2 9.23233 1.33675 10.1908 -3.5905 -1.89286 -1.84539 +307 1 9.13587 15.2239 10.1542 8.27875 -9.17261 13.8125 +308 2 8.75897 15.8188 9.50902 -6.94043 7.83547 -6.48358 +309 2 8.46187 14.5466 10.3059 -2.40816 2.69742 -4.7236 +310 1 0.685213 9.67274 10.114 -7.63752 22.5158 18.5003 +311 2 0.719625 10.5209 10.6443 4.69174 -21.4783 -21.4849 +312 2 1.56632 9.47392 9.79675 4.15873 2.44002 -0.184199 +313 1 17.1428 4.74332 7.9842 -7.49261 0.0436566 15.7002 +314 2 16.4923 5.43036 8.24486 9.33931 -9.59151 -5.74994 +315 2 17.1543 4.09081 8.70481 -1.62938 8.73821 -5.69634 +316 1 14.873 14.5838 0.184633 -12.5055 -0.863041 8.47648 +317 2 15.4452 15.0773 0.785336 2.49238 5.2379 -3.7088 +318 2 14.1221 14.3325 0.749692 6.56524 -1.80757 -8.31994 +319 1 3.93739 11.0893 9.63941 -1.02455 -14.3236 -20.6383 +320 2 3.83455 11.1931 10.5803 -4.40039 8.60569 15.1914 +321 2 3.22961 11.5882 9.19534 2.92088 3.20496 1.27781 +322 1 11.4787 10.7372 1.42758 24.3197 -0.772389 9.7934 +323 2 11.803 11.5915 1.09275 -4.97826 -3.71445 3.9898 +324 2 10.5984 10.6629 1.1011 -26.1902 -1.18673 -8.43185 +325 1 13.1873 7.21634 12.6041 -15.1781 -16.7535 7.59792 +326 2 14.1321 7.04558 12.6338 7.66113 -4.04391 -1.22332 +327 2 12.7625 6.33802 12.7657 6.99529 16.5731 -3.03327 +328 1 9.70202 2.01155 0.798053 14.7354 3.6785 18.4689 +329 2 8.80874 1.78739 0.563168 -12.7542 -2.84597 -8.5823 +330 2 10.1462 2.35336 0.0231027 2.1886 1.53799 -6.67264 +331 1 10.5601 13.4177 4.61479 15.5689 5.45852 21.4774 +332 2 11.4398 12.9929 4.68798 -8.71776 0.745444 -2.53542 +333 2 10.4627 13.8549 5.48714 -1.1208 -2.16649 -13.1077 +334 1 14.6135 1.64587 10.9888 -15.9483 2.47769 1.03658 +335 2 15.3653 1.14828 10.6398 3.3395 9.35485 -7.37665 +336 2 14.6055 2.55489 10.6162 9.33106 -12.1869 7.67578 +337 1 14.4205 12.072 11.5247 -14.0438 -11.3661 -21.2086 +338 2 15.2325 12.1783 11.0185 5.83651 11.9615 0.736203 +339 2 13.7775 11.7491 10.8405 12.2041 8.47933 23.407 +340 1 8.16075 5.17074 9.91542 -32.2508 22.4833 15.2463 +341 2 7.26447 5.43351 10.2769 29.6925 -9.34554 -9.10024 +342 2 8.08912 4.23235 9.75273 2.68018 -15.2376 -3.85437 +343 1 1.73754 17.0197 18.4251 17.7604 24.8388 -20.6387 +344 2 2.31535 17.5448 17.7835 -20.2636 -19.608 22.2942 +345 2 1.91865 16.0976 18.2314 3.71033 -9.13614 -1.37747 +346 1 1.38218 17.4352 15.3141 25.6123 -1.10879 -8.05345 +347 2 1.40837 18.2867 15.7687 -7.1514 0.273564 3.63966 +348 2 0.483975 17.1212 15.2601 -14.2857 -2.70278 3.05549 +349 1 3.46713 5.71669 6.03858 -5.21329 -0.208659 9.269 +350 2 3.09179 6.35885 6.66621 -4.29108 -6.04245 -5.71481 +351 2 3.94628 6.22951 5.39233 13.1871 8.33197 -8.25473 +352 1 12.7108 9.52885 14.2713 4.43437 -19.6411 -8.16456 +353 2 13.1132 8.73466 13.871 -3.04318 14.9787 -8.97539 +354 2 12.4252 9.15135 15.1011 -11.0135 5.38653 13.5706 +355 1 4.12803 15.1962 7.19495 12.4066 -8.66704 -3.75127 +356 2 3.59847 15.8823 6.77325 5.03517 9.17322 -2.57748 +357 2 5.08076 15.3227 6.96437 -18.0652 5.77836 0.725546 +358 1 0.842345 8.89099 15.1297 2.31502 -25.1166 0.479797 +359 2 0.506769 9.78853 15.0967 4.66165 8.13805 -4.97691 +360 2 1.56169 8.8202 14.4757 -4.5077 5.49756 1.76436 +361 1 12.9722 8.22706 10.1223 30.4908 -35.0116 2.62512 +362 2 13.7358 7.69898 9.75664 -18.6412 19.8455 -0.140907 +363 2 12.9154 7.83668 11.013 -6.3959 11.2287 -1.2259 +364 1 15.209 8.0796 3.38747 1.18456 -35.8933 6.76248 +365 2 14.5518 7.57266 2.91157 -10.3511 16.9608 -18.4151 +366 2 15.3784 7.42989 4.0872 14.9983 19.582 11.3682 +367 1 17.1108 6.70081 18.626 -14.4882 23.5427 -0.564853 +368 2 16.573 5.93167 0.182006 3.19594 -3.93797 2.70551 +369 2 16.4292 7.40436 18.4932 17.3888 -11.7094 -2.73385 +370 1 8.93374 7.05508 7.97597 -34.6157 -22.4872 9.48373 +371 2 9.83531 7.32727 7.97774 29.5921 7.62374 2.22252 +372 2 8.80811 6.41093 8.72029 6.54491 10.6746 -16.3243 +373 1 12.5312 0.423333 1.1911 6.44852 -9.8202 9.01884 +374 2 13.2753 0.834119 1.64897 1.63592 5.99122 -1.78887 +375 2 12.9315 0.0607692 0.396252 -6.77848 2.89528 -3.69601 +376 1 5.75537 14.98 14.4363 12.3645 2.0371 -4.21343 +377 2 4.82148 15.0687 14.6213 -16.3449 4.01416 5.01671 +378 2 6.0882 15.8478 14.162 -3.83146 3.10822 0.706071 +379 1 3.69037 6.49544 1.72037 -3.07239 6.81288 -7.41536 +380 2 3.43088 7.36249 1.36332 1.27628 -12.1507 -2.18765 +381 2 3.67848 6.67228 2.6574 4.23334 -3.71069 10.2966 +382 1 3.82256 11.2843 12.3046 -0.864415 -4.77059 0.0245619 +383 2 4.71622 11.5939 12.5181 -0.579536 5.4381 2.57712 +384 2 3.18979 11.9063 12.6819 -0.230908 7.2683 5.57723 +385 1 5.33149 3.8717 15.6726 -21.611 69.2317 6.1195 +386 2 6.02506 3.28248 15.4947 35.9646 -33.3333 -4.61122 +387 2 5.75271 4.79171 15.6869 -18.1046 -35.0984 -1.75377 +388 1 13.9893 10.0773 4.7789 22.4286 4.91544 -48.853 +389 2 14.2819 9.66907 5.58109 5.23319 -9.97863 19.9681 +390 2 14.5573 9.69868 4.0468 -17.0356 6.64649 24.2901 +391 1 7.62039 17.28 9.03644 -1.79817 -13.3385 2.54351 +392 2 6.82618 17.452 9.57294 2.68689 7.94648 -2.92213 +393 2 7.87136 18.0666 8.53956 -0.560867 8.99315 -4.02364 +394 1 4.58082 14.4709 3.89205 3.13293 1.46958 -13.0867 +395 2 4.66344 15.3386 4.31009 -0.0981131 -0.860678 2.59791 +396 2 4.56838 13.761 4.54421 -0.137719 -0.424919 8.72805 +397 1 14.11 7.4138 15.8858 20.156 9.8447 -1.08692 +398 2 14.9007 7.50898 15.3123 -12.2349 -4.78906 9.9244 +399 2 14.35 7.89712 16.7003 -4.15301 -9.39138 -6.29924 +400 1 2.88871 18.3931 1.90601 -10.0733 25.2579 5.70796 +401 2 2.56074 17.6209 1.45485 -4.97176 -8.65563 -11.6917 +402 2 2.08224 0.29716 2.10455 27.8478 -15.7521 2.2348 +403 1 8.03506 1.57584 4.43091 11.32 6.26446 5.75526 +404 2 7.34029 2.01323 3.92479 3.96785 0.109851 -4.32136 +405 2 8.88243 1.87946 4.04557 -12.5027 -7.48646 4.71123 +406 1 2.59748 14.2159 17.7933 -41.9258 1.66076 -8.0641 +407 2 1.85609 13.5734 17.9588 19.2075 16.8599 2.55802 +408 2 3.39352 13.7425 17.9784 23.6145 -16.2032 6.42715 +409 1 1.02442 1.99672 13.9281 17.4639 2.95853 -13.5386 +410 2 1.00308 1.87917 14.8709 4.63864 -6.80727 18.6653 +411 2 18.7659 2.1043 13.6716 -21.6962 3.88026 -3.66909 +412 1 4.27686 0.20187 13.9044 10.5162 4.04171 -16.044 +413 2 5.10447 18.3372 13.9403 -4.05013 6.4475 2.1433 +414 2 3.72354 18.5099 14.5979 -6.57077 -5.71295 14.511 +415 1 7.38305 1.01959 18.4815 -37.4449 7.12948 8.58409 +416 2 7.61008 0.74545 17.6036 5.58611 -6.30497 -21.5445 +417 2 6.41018 1.26146 18.4662 31.347 -10.6343 7.25927 +418 1 15.7518 18.4403 13.8831 -5.31168 6.41878 -7.08883 +419 2 14.7988 18.525 13.6912 13.3949 -2.54728 9.28792 +420 2 15.9153 18.5927 14.8217 -8.96218 -2.42265 4.9219 +421 1 10.3004 4.59906 16.2125 -26.9192 -42.5531 9.44494 +422 2 11.2318 4.75068 16.1287 26.1471 2.80018 1.93501 +423 2 10.2211 3.60629 16.3773 -0.864587 37.9812 -10.9337 +424 1 15.8848 17.7109 4.47524 -26.0192 -17.7161 -6.69824 +425 2 16.416 18.4558 4.72522 12.9982 18.1701 2.23702 +426 2 14.9575 17.9834 4.62838 14.848 -2.41832 2.25768 +427 1 6.86545 17.6577 14.0262 -6.12412 -8.41921 6.45462 +428 2 7.47866 17.6693 14.7646 2.09746 6.93436 13.8689 +429 2 7.44902 17.4838 13.2997 11.4214 -0.145135 -19.8537 +430 1 13.1703 6.41318 6.52816 -11.7529 -0.316938 -15.1514 +431 2 13.9829 6.90375 6.37155 7.88734 -3.14145 2.99861 +432 2 12.7537 6.33512 5.64174 6.34445 -4.78434 12.9923 +433 1 7.85335 2.30114 9.49646 -14.1039 1.33546 -28.6309 +434 2 7.23443 2.06415 10.1901 -3.07143 2.26257 12.1486 +435 2 7.33833 2.15664 8.66054 15.7097 0.546065 18.7565 +436 1 15.1664 14.7315 13.8676 -13.4222 3.7476 -0.777794 +437 2 14.8716 15.1233 14.7167 4.70885 -6.20173 -11.3706 +438 2 14.4912 14.9291 13.1959 7.90291 2.0321 9.20294 +439 1 9.36434 8.4507 3.85153 -5.45323 -8.44175 -9.3174 +440 2 10.195 8.80526 4.18009 6.07261 4.07641 1.89943 +441 2 9.48655 7.50041 3.73575 1.17631 -1.18483 4.07146 +442 1 17.585 13.5529 16.4533 28.0827 9.29223 -15.0932 +443 2 16.6463 13.3857 16.5308 -13.0105 5.34146 -4.98563 +444 2 17.7372 14.3421 15.8749 -12.9185 -11.1551 11.5131 +445 1 5.00344 10.4544 2.83444 15.3623 2.39709 8.30796 +446 2 5.84337 10.0047 3.04968 -12.8086 4.14038 -0.288119 +447 2 4.84487 11.029 3.60723 -3.54173 -2.25206 -8.41364 +448 1 3.64071 8.37653 9.83285 -3.63557 -2.42467 19.3481 +449 2 3.86873 9.30617 9.70655 -0.364806 7.27712 -2.43853 +450 2 3.42279 8.30417 10.789 5.82381 -0.771913 -15.5307 +451 1 16.012 6.92262 5.85834 3.10414 -0.205141 -1.95775 +452 2 16.7064 7.38617 6.35888 -2.44937 -6.94247 -7.87698 +453 2 16.3342 6.01666 5.66219 -6.01431 14.0457 5.91674 +454 1 15.3573 7.28861 8.91428 -7.73552 23.9623 -29.5509 +455 2 15.9286 7.60908 9.59449 17.6585 1.69923 20.6432 +456 2 15.3281 8.05346 8.27817 -7.4668 -29.0722 12.6462 +457 1 6.23444 12.7891 12.7562 -16.1216 7.07791 -6.67583 +458 2 7.04381 12.3675 13.028 12.7717 -9.63916 7.37694 +459 2 6.08648 13.5082 13.3891 2.20208 -1.21591 -2.77254 +460 1 12.1275 4.60499 13.1618 30.5736 27.4894 8.79026 +461 2 12.1815 4.60813 14.1323 1.45244 -2.14521 -6.91324 +462 2 11.4269 4.052 12.8891 -30.6572 -22.7655 -2.33684 +463 1 11.4418 8.05897 7.8749 4.39649 -6.11408 4.26725 +464 2 12.0054 7.38105 7.40707 -4.89778 19.9996 19.2901 +465 2 11.7913 8.23063 8.79017 -1.61454 -12.0828 -25.9053 +466 1 16.8934 10.7552 7.64898 5.958 -15.487 6.46706 +467 2 17.5218 10.034 7.45777 0.434714 4.65833 3.39608 +468 2 16.8005 11.223 6.82193 -0.787623 15.1873 -12.5781 +469 1 5.19162 18.0101 10.6182 -11.7475 -9.51575 -5.50364 +470 2 4.6689 17.2843 11.0141 12.267 13.7571 -4.22389 +471 2 4.61649 18.3258 9.88348 13.0529 -7.1725 20.3587 +472 1 7.61953 17.4141 1.49962 -5.28373 3.7131 11.8258 +473 2 8.17503 16.7132 1.19553 7.57367 -21.9054 -5.9523 +474 2 7.57614 18.0024 0.755384 -3.403 20.0604 -6.05803 +475 1 1.93154 12.9424 13.6297 4.26026 1.62766 0.165619 +476 2 1.31807 12.4855 14.2164 3.08324 -4.19991 0.575461 +477 2 2.34989 13.6289 14.1741 -4.48691 2.36366 -2.57882 +478 1 9.34851 6.7636 14.8211 -2.90069 2.43692 -15.7898 +479 2 9.659 5.88476 15.1078 3.08688 5.56829 -7.87962 +480 2 9.50722 6.89182 13.8456 0.484936 -6.74561 22.7152 +481 1 15.2631 4.37275 10.7209 -0.391742 -1.67154 5.71992 +482 2 16.1506 4.03655 10.897 1.37527 -0.677682 -8.66997 +483 2 15.1154 4.97006 11.4686 -2.24536 -2.27818 -6.11794 +484 1 11.4934 6.22632 -0.0241442 -6.06296 -11.7718 -8.66306 +485 2 11.6483 5.30933 -0.309107 4.27028 6.28431 2.83608 +486 2 10.5284 6.3165 18.5406 6.28072 6.83613 2.73886 +487 1 18.4725 11.4275 14.8977 -1.36673 1.10287 -33.3787 +488 2 18.0559 11.937 14.1605 1.63397 -11.827 9.6186 +489 2 18.3384 12.0011 15.6307 -5.5196 20.2825 24.8766 +490 1 7.17852 9.29091 7.31266 -12.1778 -5.70725 -5.55247 +491 2 6.76293 8.42612 7.50122 5.49043 12.248 4.67896 +492 2 8.1168 9.11866 7.26453 10.5183 -1.31775 0.108346 +493 1 18.3399 15.3762 12.1294 6.77425 7.85663 0.444206 +494 2 0.624383 15.5788 11.9067 -6.5428 -1.83873 1.38378 +495 2 17.7957 15.9125 11.5264 -1.63248 -5.99386 0.103645 +496 1 16.5386 4.34911 5.2503 -38.2238 -21.0357 51.9327 +497 2 16.6701 3.96728 6.16388 -6.69454 12.6485 -26.055 +498 2 17.3775 4.32019 4.85382 41.1543 5.3392 -22.1831 +499 1 17.7341 3.08223 10.7755 -2.39486 19.3144 10.8573 +500 2 18.6554 3.32717 10.9901 -9.67157 -6.39923 -2.68969 +501 2 17.7406 2.18791 10.4534 3.10102 -17.6187 -9.33289 +502 1 12.3347 18.6584 10.1394 22.1152 -18.6094 -11.1242 +503 2 11.4269 0.285024 10.28 -5.50333 15.1479 5.74269 +504 2 12.9381 0.769801 10.2484 -7.53185 0.18177 2.36971 +505 1 10.4414 9.72052 12.5804 5.49259 18.5488 2.65475 +506 2 11.2372 9.86145 13.1232 -3.33328 -5.81976 -2.33485 +507 2 10.4983 8.8205 12.2639 -0.9125 -13.8337 3.2089 +508 1 0.576047 2.60181 7.2501 -1.65995 13.3288 -12.3458 +509 2 0.268028 3.48996 7.49944 2.28387 -7.91724 -1.96879 +510 2 1.05133 2.26453 8.01425 -2.57801 -1.32252 3.73717 +511 1 0.35756 15.2681 6.96461 -6.18578 -18.242 -64.2832 +512 2 0.656709 14.9904 7.8095 9.46814 -3.47663 35.1726 +513 2 0.533918 14.474 6.37104 -3.56161 26.9089 25.8891 +514 1 17.0554 6.8805 14.912 24.4713 -1.83906 11.5387 +515 2 17.8121 7.50971 14.9246 -13.4777 -6.95308 -2.51376 +516 2 17.3666 6.12061 15.452 -8.01529 8.59931 -8.57008 +517 1 9.11821 12.4896 7.9597 -39.3936 14.7629 -4.46817 +518 2 9.45619 11.6923 7.5591 7.68398 -14.1787 -12.8233 +519 2 8.20522 12.6235 7.56541 34.2702 -5.52337 13.9854 +520 1 1.14934 1.62531 2.7512 -10.6975 -16.4856 11.3042 +521 2 0.557887 1.95566 2.07466 1.95024 15.5996 -8.59751 +522 2 1.5216 2.35039 3.25303 6.14281 9.13632 1.51194 +523 1 4.18801 15.1235 9.83797 -4.3571 13.9944 -8.49019 +524 2 4.15169 15.4364 8.91421 -7.63033 -5.74015 13.5827 +525 2 5.04261 14.6826 9.83518 3.69587 -3.91806 9.7151 +526 1 7.38616 2.29059 14.8987 -4.38475 3.80451 -15.2317 +527 2 7.23636 1.51405 14.3418 -1.55041 0.530275 6.25745 +528 2 7.45512 3.02747 14.2682 8.09838 -6.66607 2.4433 +529 1 18.2954 14.5248 2.13868 21.7335 16.5649 1.154 +530 2 0.530315 14.9412 2.32201 -13.6123 -15.8317 -3.76049 +531 2 17.7186 15.2797 1.96871 -6.10103 1.83177 1.59348 +532 1 10.0818 2.68123 12.8993 0.213282 -13.011 -16.4533 +533 2 9.9804 2.00538 12.1749 2.58274 17.6757 17.7308 +534 2 9.30115 3.24961 12.8455 -1.77409 -0.0668197 -1.90377 +535 1 2.92042 8.79199 13.1038 3.60331 12.5418 -6.85933 +536 2 3.19747 9.71233 12.8787 -2.51528 -19.5049 2.84802 +537 2 3.74925 8.3139 13.2755 -6.12566 -1.47569 1.35688 +538 1 3.2826 8.6043 3.78787 -1.06696 -30.5523 53.3514 +539 2 3.6648 9.24286 3.23576 21.5217 31.7748 -30.2126 +540 2 3.73659 8.75462 4.6619 -18.3855 -4.45548 -24.3241 +541 1 5.99503 7.23605 8.68049 -5.70462 -6.01689 -7.52618 +542 2 5.88732 6.32464 8.37432 -5.09887 -1.13221 5.21957 +543 2 5.15444 7.50455 9.08765 4.58913 -3.02319 1.70333 +544 1 14.8694 1.67632 1.824 4.95495 -3.07302 -21.4612 +545 2 14.923 2.54765 2.20438 -6.9063 6.82762 18.8127 +546 2 15.1986 1.83723 0.92353 -1.55356 -7.84532 7.79991 +547 1 8.71318 14.9586 0.633889 5.3189 4.72704 12.5337 +548 2 9.41548 15.0137 1.3229 -12.9747 -8.59069 -7.21106 +549 2 7.9574 14.4505 1.00218 9.17218 5.81258 0.251254 +550 1 15.3522 1.50057 7.22863 -1.61242 -14.2743 -3.26221 +551 2 14.7819 0.961058 6.63945 7.54361 11.5891 10.8038 +552 2 14.804 2.18796 7.6304 -1.95204 4.928 -5.75504 +553 1 4.88832 12.8638 18.4669 14.1773 6.076 10.5021 +554 2 5.16486 12.9634 0.754115 -2.57074 -3.9589 -10.7447 +555 2 5.64539 13.2163 17.9734 -6.87045 1.01425 -0.872896 +556 1 15.3658 8.71105 18.1022 0.313753 1.99863 -15.4271 +557 2 15.6825 9.25538 17.3367 -2.33671 -6.91366 23.9636 +558 2 15.2177 9.29821 0.21527 -1.89476 6.92048 -0.597105 +559 1 12.0025 3.14868 18.2874 -4.08601 9.85731 -2.22671 +560 2 12.1144 3.11564 0.603374 4.33643 -8.86024 -4.9595 +561 2 12.4653 2.40747 17.863 0.0624807 -1.52737 7.22507 +562 1 13.2135 12.7035 5.12884 9.73413 0.384952 2.90661 +563 2 13.7 11.8654 5.00774 -9.98906 4.00813 0.0328844 +564 2 13.4141 12.9701 6.04548 -3.79483 -4.91087 -6.97232 +565 1 6.18903 7.09371 0.234798 3.60985 -26.8596 -14.0682 +566 2 6.2071 8.04594 18.8061 -7.0012 19.4313 6.00448 +567 2 5.26363 6.79856 0.279731 4.49735 8.94005 5.55961 +568 1 17.7003 15.89 14.853 -18.1963 11.2058 -20.3772 +569 2 16.8346 16.3247 14.8039 6.19322 -4.54728 12.6057 +570 2 17.8435 15.7325 13.9057 13.4875 -6.37623 4.18836 +571 1 13.0834 0.870867 16.8965 -0.161813 1.3846 -1.86612 +572 2 14.0072 0.582211 16.892 1.10768 1.72224 0.871652 +573 2 12.5754 18.726 16.653 1.71204 -0.315799 1.62538 +574 1 10.8945 14.507 7.48359 31.9827 12.7774 -14.5262 +575 2 10.2535 13.8684 7.76101 -18.1255 -14.8352 9.6937 +576 2 11.748 14.0397 7.49435 -7.74827 -1.48019 1.36014 +577 1 17.7521 8.40099 2.11802 -4.68381 10.101 13.2464 +578 2 16.8759 8.32923 2.50971 -7.38706 6.94009 5.95596 +579 2 17.7532 7.67887 1.5098 2.25561 -17.6604 -22.6471 +580 1 12.5231 7.84865 2.0094 -2.30264 15.9804 1.37474 +581 2 12.1379 8.74758 1.97393 9.3167 -10.0751 -1.70323 +582 2 12.325 7.4571 1.14918 -4.66948 -5.90928 2.89896 +583 1 11.972 14.5025 10.3451 -2.96888 12.9379 -2.77484 +584 2 12.1874 14.7132 9.42348 -1.74009 -6.18971 10.5862 +585 2 11.0277 14.706 10.4449 2.87573 -2.36207 -4.30421 +586 1 6.71227 6.84952 15.5806 25.6498 -3.78319 22.6581 +587 2 7.68828 6.90632 15.3859 -23.8939 0.442938 5.1849 +588 2 6.62279 7.02219 16.5478 -0.830995 -1.23763 -22.0679 +589 1 7.92027 4.40739 13.1357 7.88731 17.7005 28.4833 +590 2 7.20639 4.70613 12.563 -5.96959 3.19417 -4.54574 +591 2 8.05118 5.13552 13.7952 -2.84521 -16.8776 -20.7331 +592 1 13.2899 12.2294 14.3537 -3.3223 6.18653 6.3482 +593 2 12.9901 11.3268 14.1873 4.87208 -4.78833 3.90165 +594 2 13.6879 12.5058 13.5223 1.91273 0.0234059 -4.06458 +595 1 14.5389 9.51264 7.32918 -7.01434 -27.1539 -11.6023 +596 2 15.2763 10.0624 7.53312 20.4851 16.6908 8.43718 +597 2 13.8132 9.80854 7.861 -14.3264 8.19434 11.2695 +598 1 12.68 16.8773 3.29092 2.11558 25.6431 -8.94229 +599 2 12.7733 17.3894 4.13219 -1.2803 -9.72294 -18.9636 +600 2 12.6793 17.5234 2.53176 -0.650571 -10.0569 23.6182 +601 1 0.970813 7.05439 17.3478 19.6691 8.71735 -9.44801 +602 2 0.0997442 7.2771 17.6294 -27.888 -7.65058 15.2547 +603 2 1.07493 7.61203 16.5711 5.30897 3.90939 -5.98442 +604 1 13.0218 4.86702 15.7977 -14.5255 -22.5737 -0.430567 +605 2 13.6652 4.12206 15.7771 -2.73243 23.3382 0.768668 +606 2 13.4898 5.70142 15.8866 10.098 7.61534 -0.732483 +607 1 2.35004 3.40025 5.07686 -12.6408 -17.529 -7.45963 +608 2 1.84891 3.15034 5.87751 4.27568 5.0167 -3.29201 +609 2 2.74325 4.26374 5.21682 1.23402 6.29722 12.7184 +610 1 8.14417 10.9001 13.7499 9.28616 -30.1931 45.6744 +611 2 7.9506 10.3552 14.611 8.46781 36.9232 -44.8577 +612 2 9.00813 10.5574 13.4404 -10.6035 2.99953 -2.14266 +613 1 13.0821 1.49083 13.2989 5.3891 9.28887 -24.1834 +614 2 13.7872 1.3627 12.5959 -25.8284 12.5052 17.3021 +615 2 12.4896 2.22352 12.9857 19.0093 -19.6589 8.86348 +616 1 6.62484 13.6674 2.02561 -2.30013 1.61314 -5.1998 +617 2 5.94206 14.1599 2.51404 7.05284 -6.38204 5.2583 +618 2 7.12137 13.1184 2.65568 -4.11309 1.61678 2.96157 +619 1 15.7857 6.33001 12.4874 9.47505 -1.37582 18.5865 +620 2 16.2809 6.76838 11.7933 3.97273 7.7159 -2.96061 +621 2 16.3586 6.41799 13.2831 -12.689 -0.09302 -8.30077 +622 1 16.7471 0.613682 9.52771 11.5447 -14.6629 17.7173 +623 2 16.7567 18.2848 9.57147 -3.7535 4.88819 4.87116 +624 2 16.43 0.840462 8.66213 -13.2327 5.78697 -22.1845 +625 1 6.19152 11.681 8.24955 3.80355 -8.99636 -2.81467 +626 2 5.36879 11.4903 8.73023 3.19436 -10.2741 -4.0588 +627 2 6.55865 10.8405 7.8788 -10.8203 9.76695 14.653 +628 1 2.78766 8.56788 0.409413 -52.7319 2.11899 -11.855 +629 2 2.08185 8.03903 18.552 32.3713 20.2249 14.5342 +630 2 2.26775 9.27739 0.866586 13.6595 -12.5773 -9.56289 +631 1 10.1003 10.2385 6.61376 -10.8952 5.58665 6.62413 +632 2 10.4921 9.47201 7.04387 8.70092 -2.05853 1.95229 +633 2 10.597 10.3787 5.79806 -1.31095 -2.00825 -0.431677 +634 1 6.84539 15.7603 6.76774 -1.32488 -8.5888 0.285168 +635 2 7.15445 16.2386 7.5582 -1.07119 -0.859265 -6.52036 +636 2 7.16186 16.249 5.99512 -0.908646 8.8198 -0.167177 +637 1 6.64088 12.8596 5.99362 6.27305 7.11444 -12.0385 +638 2 6.74407 13.8044 6.07603 1.27228 12.7365 2.69296 +639 2 6.25078 12.5941 6.82297 -5.96354 -7.18103 4.5408 +640 1 16.6867 12.5722 9.84379 -3.64815 -5.06409 7.40683 +641 2 16.7505 11.8965 9.15556 3.82735 1.49832 -4.74998 +642 2 16.8024 13.43 9.4304 0.212763 1.2752 -2.86494 +643 1 6.31521 2.74143 2.73106 -6.87016 -8.03266 -4.4066 +644 2 6.55003 3.64872 2.52358 -0.655364 10.9132 -0.0341781 +645 2 5.98199 2.35933 1.9027 -1.39596 -0.0669143 5.2552 +646 1 10.642 2.89265 3.25205 -8.44131 -1.48195 -5.66324 +647 2 10.1183 3.68518 3.4139 4.92295 3.00907 1.37692 +648 2 10.2968 2.53281 2.41595 2.77965 2.00448 3.56419 diff --git a/examples/amoeba/dump.water_box.hippo.1 b/examples/amoeba/dump.water_box.hippo.1 new file mode 100644 index 0000000000..33463a3a5d --- /dev/null +++ b/examples/amoeba/dump.water_box.hippo.1 @@ -0,0 +1,7227 @@ +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.67966 7.08769 17.9461 -19.3527 -13.639 6.25201 +2 2 7.80945 6.75579 18.2607 18.4949 11.1596 -6.01922 +3 2 8.72223 6.81424 17.0254 5.85599 -0.890166 3.45586 +4 1 18.5257 8.24445 6.83762 11.8085 12.5587 58.8481 +5 2 0.216892 7.89544 6.05003 10.8935 -14.9684 -50.5046 +6 2 0.444268 7.82601 7.5302 -15.2958 7.9793 -8.89884 +7 1 8.37906 18.5504 6.81463 25.5385 6.64228 -3.75624 +8 2 9.34042 0.098069 6.73406 -20.9151 -2.68951 1.38711 +9 2 7.93962 0.573676 6.26984 -0.656308 -0.308718 3.40946 +10 1 6.58995 1.84432 11.7198 46.6828 -15.9611 -12.5859 +11 2 5.88543 2.40231 11.9251 -37.6261 28.8114 18.1934 +12 2 6.18153 1.06275 11.3693 -6.58868 -16.6156 -5.55691 +13 1 7.1466 5.75358 2.33152 -56.1364 42.5085 -2.61462 +14 2 6.36812 6.12603 2.86268 40.1937 -23.4301 -4.21826 +15 2 7.02502 6.29465 1.5182 16.3021 -20.7884 10.9258 +16 1 16.2164 10.1388 16.1382 -32.0875 21.5958 16.7579 +17 2 16.9509 10.2747 15.5847 32.9015 -1.03241 -20.1636 +18 2 15.8498 11.0405 16.2399 1.98783 -14.756 2.71439 +19 1 10.6046 15.0374 2.30369 -8.13409 -25.494 -7.18668 +20 2 10.5292 14.3949 3.01849 1.41683 -0.603724 2.75561 +21 2 11.0236 15.78 2.70962 11.6057 19.8833 4.5888 +22 1 17.1624 8.24409 10.3708 13.0676 7.07862 9.73504 +23 2 16.5528 8.68798 10.966 -4.65968 7.37974 1.83434 +24 2 17.9421 8.82333 10.3208 -6.34155 -10.1937 -2.20396 +25 1 14.901 15.8652 16.3167 18.01 -6.87509 18.5636 +26 2 14.0225 16.1982 16.2525 -26.9236 12.7201 -6.50875 +27 2 14.9141 15.482 17.2099 2.63751 -6.05913 -7.59706 +28 1 12.1752 13.3771 0.408263 -11.3168 6.26442 9.98381 +29 2 12.0579 13.8465 18.23 5.67057 -4.50268 -16.0578 +30 2 11.6217 13.8904 1.00796 3.42507 -1.00312 9.73088 +31 1 9.27358 5.34243 4.05546 -35.2781 32.5984 16.8393 +32 2 8.64594 5.4665 4.83764 28.3783 -16.8163 -28.778 +33 2 8.74177 5.68615 3.30282 7.52493 -14.9247 9.48156 +34 1 1.83016 4.27673 11.6495 -21.1764 37.5598 -8.14901 +35 2 1.70328 5.22377 11.9391 6.02814 -28.7768 -8.29565 +36 2 2.40811 3.85345 12.2597 13.4728 -11.3181 18.3421 +37 1 1.96438 6.83299 8.3731 -11.1902 3.43717 -25.3738 +38 2 2.49614 7.21578 9.0563 9.35281 -0.190165 18.6039 +39 2 1.81128 5.90585 8.57354 7.84101 -3.79534 5.21373 +40 1 5.40557 4.38899 7.93274 -6.81526 4.7224 -2.63907 +41 2 5.53738 3.43895 7.78131 -7.79962 9.88898 0.533881 +42 2 4.75516 4.73491 7.29062 10.7858 -16.238 7.24535 +43 1 3.23 2.92842 17.5524 -0.538114 20.9936 16.7312 +44 2 3.93109 3.19827 16.9402 -0.965509 8.21721 4.01649 +45 2 3.00444 3.70897 18.1497 6.13449 -29.114 -23.6081 +46 1 7.4624 5.26283 6.13117 9.12728 4.25284 -1.73168 +47 2 8.02565 5.58849 6.88177 -24.817 -14.4341 -14.6054 +48 2 6.93508 4.45577 6.3254 16.0496 22.0303 12.0173 +49 1 9.77896 7.02384 11.9834 11.1205 -3.87253 23.9446 +50 2 10.2721 6.37256 11.5011 10.9222 -10.0302 -1.39678 +51 2 9.1532 7.31587 11.3499 -23.6433 13.1239 -20.7784 +52 1 14.1167 3.54999 8.03003 -30.7601 -1.60704 -37.9113 +53 2 13.4732 4.22413 7.73132 15.1608 -10.723 4.30178 +54 2 14.3809 3.80189 8.88487 12.8065 16.1495 34.678 +55 1 4.82329 17.2568 4.03846 -17.85 32.0436 -31.4073 +56 2 5.49315 17.973 4.01308 -7.71314 -24.6342 10.4391 +57 2 4.18746 17.5412 3.33843 10.9703 -13.5421 12.8553 +58 1 16.4918 16.6259 10.0493 29.9016 15.3745 -40.7533 +59 2 16.1673 16.3226 10.8594 -24.6786 -13.0437 37.8908 +60 2 15.9925 16.2084 9.33562 -4.01544 -1.82242 7.63759 +61 1 1.94489 4.93323 0.49791 29.1886 10.4759 3.59715 +62 2 2.55322 5.26335 1.2053 -17.2324 -10.4098 -15.9422 +63 2 2.08253 5.591 18.4408 -14.7087 -3.80383 3.81857 +64 1 11.816 13.3571 16.2711 -7.8083 1.12937 6.2001 +65 2 11.2371 12.6203 16.5671 13.3708 1.96491 -16.2063 +66 2 12.2446 13.1893 15.4079 -11.197 -7.32732 11.8633 +67 1 10.105 11.0651 16.9545 16.7158 -32.7784 1.37979 +68 2 10.5674 10.1947 17.1295 -14.0823 30.097 -5.45833 +69 2 9.25349 10.8067 16.5912 -2.99511 2.11526 2.57572 +70 1 11.7264 17.5421 13.4742 2.50122 -25.0158 -11.214 +71 2 12.2771 16.9836 12.8968 -8.91486 0.79877 6.23222 +72 2 12.1041 18.3936 13.317 1.59091 22.4782 2.42571 +73 1 6.33029 9.31911 12.2264 15.6898 -25.4439 -25.1534 +74 2 7.02603 8.96242 11.6353 -17.823 2.07037 1.33758 +75 2 6.81249 9.95941 12.7172 5.93051 22.1649 19.4162 +76 1 16.2187 12.7249 2.70186 -8.69715 -37.3569 7.82337 +77 2 17.0292 13.1566 2.50302 19.6243 18.7999 -9.68795 +78 2 15.4982 13.3357 2.61812 -8.61102 21.6356 1.57727 +79 1 0.637202 12.5625 5.84914 -32.6687 7.10288 -2.13707 +80 2 0.892312 12.5507 4.90771 -4.51242 -1.40786 13.4578 +81 2 18.3039 12.804 5.85329 37.5994 -4.88925 -6.97833 +82 1 5.19922 16.3781 18.5047 -7.71264 -0.634541 -12.9921 +83 2 5.80284 15.8543 17.9455 2.11468 10.7978 13.7187 +84 2 5.67034 16.9636 0.462296 7.23142 -5.58048 -3.24093 +85 1 0.510145 7.62945 4.0545 45.851 19.5686 -25.4796 +86 2 18.5719 8.14656 3.45296 9.61971 -16.7838 10.3831 +87 2 1.46496 7.74082 3.66917 -52.3954 -1.94356 25.3273 +88 1 3.14672 8.89584 6.52626 -54.2957 5.34018 -1.73828 +89 2 3.50609 8.59991 7.35294 9.18701 -2.26398 8.55435 +90 2 2.14573 8.92962 6.68203 45.3688 -0.563656 -9.64228 +91 1 7.30854 10.3037 16.1717 -0.0267506 0.140778 15.7468 +92 2 6.56213 10.4624 15.5802 1.32412 -0.384411 10.7132 +93 2 6.99303 10.278 17.1118 0.130505 3.94788 -23.0495 +94 1 11.1122 1.06968 4.98939 -2.83136 -16.8604 13.0177 +95 2 11.0776 1.97142 4.64864 2.2702 -4.31387 -11.6367 +96 2 10.7048 0.433547 4.37027 2.96408 14.9419 -2.56144 +97 1 4.45204 2.70061 13.2052 -8.32298 -31.9478 35.5434 +98 2 4.60333 3.05865 14.0914 -0.476624 15.5497 -15.2927 +99 2 4.38645 1.737 13.4626 0.207127 24.1129 -25.2696 +100 1 8.42792 10.0237 1.78469 -10.6267 -17.9408 16.848 +101 2 8.3405 10.6377 2.53622 4.43246 -2.98222 -4.40025 +102 2 8.49672 9.11244 2.17467 4.60711 29.3182 -9.45134 +103 1 10.5335 1.75383 15.546 -31.9958 -1.22726 0.532554 +104 2 11.3977 1.82718 15.9216 23.4057 -5.242 -0.0927752 +105 2 10.5608 1.78317 14.5837 3.34522 3.38855 0.282019 +106 1 2.77693 12.941 7.74821 -10.6415 2.34425 -2.27994 +107 2 3.28797 13.5733 7.23382 5.58977 0.334345 4.09149 +108 2 1.98704 12.8256 7.20013 5.22386 -8.52712 2.54059 +109 1 3.63517 11.6895 5.33963 -10.2259 -13.0028 -10.3717 +110 2 3.35385 11.0502 6.03137 4.73753 15.317 -16.6328 +111 2 2.8758 11.855 4.74058 11.3048 -4.09559 12.5928 +112 1 6.88803 14.474 16.8428 -13.42 9.46677 6.94107 +113 2 7.55973 13.8293 16.6383 4.5229 -1.76969 -1.40507 +114 2 6.60381 14.8838 16.0165 0.0834179 -9.06129 -0.120708 +115 1 14.1722 14.5374 3.41536 20.1951 -3.19134 -21.8839 +116 2 13.6514 15.2845 3.14096 -9.23852 13.3738 0.77613 +117 2 13.8512 14.2508 4.25439 -13.5451 -9.47926 16.7085 +118 1 8.28226 18.1809 16.0824 -9.43856 -15.6135 -5.07226 +119 2 8.77677 17.3494 16.3071 1.43839 31.5077 -5.33478 +120 2 8.7603 0.384816 15.9919 11.1327 -19.5096 4.24776 +121 1 4.73724 1.61643 4.90111 5.86874 37.6921 -30.6753 +122 2 3.96969 2.16837 5.15263 9.12039 -10.9712 -6.28456 +123 2 5.18465 2.1484 4.15475 -17.6049 -26.8232 41.7187 +124 1 15.1457 12.8616 16.4403 -17.0638 -11.2899 43.408 +125 2 14.6041 12.8692 17.2613 22.7365 8.03356 -12.6578 +126 2 14.49 12.6307 15.8136 -17.0236 -4.89604 -35.7974 +127 1 15.779 18.3837 16.786 48.5063 8.0766 44.3104 +128 2 16.5108 18.615 17.4688 -41.9285 -7.99937 -34.0327 +129 2 15.7694 17.4186 16.7687 -10.3466 2.2793 -1.1406 +130 1 1.1383 1.1331 16.5571 -3.54071 10.9478 5.94974 +131 2 1.96551 1.50352 16.9177 -15.9767 0.55296 -3.51275 +132 2 0.420521 1.53444 17.0916 21.5279 -7.8795 -5.43288 +133 1 18.0817 4.5907 15.863 15.8138 -19.1991 -2.64562 +134 2 18.5818 3.91936 15.3489 -11.6552 16.5822 9.8521 +135 2 18.5602 4.7339 16.6874 -1.16116 -1.56098 -3.02727 +136 1 12.22 16.9378 16.1148 -9.97587 -12.4224 57.0196 +137 2 11.409 16.6934 16.6676 29.0172 6.05041 -31.7989 +138 2 11.9646 17.3216 15.2917 -14.4882 2.9648 -22.1743 +139 1 15.8709 2.55221 17.9707 -3.56258 26.452 -16.7944 +140 2 15.7355 3.48355 18.2574 6.35046 -25.5765 3.86241 +141 2 15.6659 2.59235 17.0072 6.0189 -6.56803 19.8103 +142 1 6.70868 13.791 10.2637 1.94011 22.9489 3.02058 +143 2 6.59347 13.548 11.1958 0.710608 -4.45224 -7.92394 +144 2 6.58252 13.0514 9.6765 -3.73143 -16.591 0.344408 +145 1 10.146 18.2027 2.80372 16.894 35.9 -12.6825 +146 2 10.2207 0.331961 2.18345 -1.03174 -23.6422 14.9845 +147 2 9.26571 17.8868 2.67703 -18.7462 -7.34721 -7.1199 +148 1 2.97538 17.748 6.06078 -27.2244 1.77787 1.96995 +149 2 2.09399 17.6473 5.67013 1.23544 -3.46851 16.5241 +150 2 3.45883 17.8838 5.26396 32.1509 0.10025 -8.47089 +151 1 12.558 17.0134 7.97028 2.72879 -14.1128 -3.91884 +152 2 11.9572 16.2512 7.82085 4.20569 13.3061 15.6125 +153 2 12.4657 17.4524 8.83591 -10.4039 -6.95813 -9.08653 +154 1 14.8795 15.2862 8.28544 5.56082 -19.5077 38.9848 +155 2 13.9824 15.6136 8.40666 -1.04882 8.68143 -14.5015 +156 2 15.2312 15.4641 7.43118 2.2507 10.8701 -29.8329 +157 1 17.5429 18.3228 0.375372 -51.3852 -2.4253 -14.1847 +158 2 18.116 17.6308 0.128652 38.5367 -21.5025 -8.63787 +159 2 17.9698 0.288559 0.934677 24.3068 21.4661 19.9837 +160 1 0.910209 10.3712 1.41143 -2.71779 -52.992 43.3073 +161 2 0.158544 9.88347 1.87089 22.0109 19.7614 -26.7074 +162 2 0.565924 11.0969 0.944383 -22.7833 34.6337 -23.5778 +163 1 1.55407 12.175 3.31087 16.6578 22.9783 50.8488 +164 2 1.36245 11.4802 2.72234 -7.70692 -21.3552 -33.2695 +165 2 1.61623 13.0206 2.87285 -0.913798 3.83337 -14.7861 +166 1 0.543127 17.2543 4.88609 29.8094 34.6465 -52.7559 +167 2 0.11032 17.9772 5.31124 -19.8915 12.2203 12.8491 +168 2 0.420366 16.4266 5.2673 -10.0988 -43.8479 36.8786 +169 1 1.10053 1.01949 9.38768 20.7334 -4.84081 3.89797 +170 2 1.46081 0.575286 10.1589 7.03147 5.77442 11.7732 +171 2 0.265613 0.594128 9.34525 -29.6063 -3.3853 -10.3011 +172 1 16.8007 2.32783 13.2877 6.1037 15.2386 -31.0559 +173 2 17.0701 2.57314 12.3549 -10.0746 -10.076 30.4228 +174 2 16.4263 1.43993 13.282 1.60122 -3.62923 0.222317 +175 1 2.45231 15.8283 12.1942 27.8718 -10.8871 18.2649 +176 2 2.8623 15.5513 13.0537 -9.1784 7.03247 -27.4702 +177 2 2.91392 15.3801 11.4615 -3.34054 6.42182 7.24567 +178 1 16.435 15.531 5.9458 21.7194 38.3058 -21.2998 +179 2 17.3808 15.5177 6.20547 -16.0791 -6.59953 3.69269 +180 2 16.4147 16.2211 5.22063 -10.9707 -19.0563 26.084 +181 1 5.84547 5.02056 11.8065 15.5941 -20.7973 -13.2046 +182 2 5.55799 5.91374 11.8891 -11.5246 18.633 11.9833 +183 2 5.09 4.45915 11.9819 -3.94875 -1.81326 3.16792 +184 1 15.2214 4.86555 0.731755 -13.7826 -16.8748 28.0949 +185 2 14.6776 4.45845 1.47821 23.1081 18.7106 -26.9415 +186 2 14.6696 4.95834 18.5986 -11.4435 4.17379 2.92627 +187 1 16.3401 16.2933 2.11217 18.5695 -12.4905 -31.3072 +188 2 16.0666 16.7695 2.87319 -12.4192 21.1701 22.1863 +189 2 16.7601 16.9279 1.50378 -10.9162 -1.12869 10.7347 +190 1 0.305885 4.87877 3.79118 -7.51195 53.5881 20.4451 +191 2 0.299338 5.85541 4.09758 -3.10789 -46.5114 -24.0825 +192 2 1.16991 4.5635 4.03062 6.84312 -11.1831 1.05233 +193 1 2.92501 14.9782 15.0356 -4.41813 7.08234 41.1019 +194 2 3.0159 14.7264 15.9987 0.986861 -4.57119 -32.7424 +195 2 2.35392 15.7535 15.1247 6.41577 5.11218 -9.25191 +196 1 1.1115 14.5727 9.55731 53.3594 20.601 -11.7192 +197 2 2.08491 14.4157 9.46275 -24.0912 20.2308 -9.17401 +198 2 0.897072 13.7408 9.90248 -29.0631 -35.5955 19.1061 +199 1 13.6501 16.6688 11.5433 6.78983 17.7214 -9.74398 +200 2 13.4697 17.4567 10.9694 -2.9322 -22.903 16.7504 +201 2 13.5721 15.8897 10.9842 -10.359 0.342192 0.0202177 +202 1 4.73098 1.47842 0.720986 -5.29759 -7.25447 0.0447572 +203 2 4.27169 1.98826 0.034225 -5.56193 -3.14325 9.7343 +204 2 4.11741 0.788607 1.06182 6.25861 16.2271 -3.37713 +205 1 1.42158 18.4663 11.9139 -14.0127 27.0043 -17.9914 +206 2 1.21766 0.394331 12.6648 1.7087 -1.58128 0.41261 +207 2 1.94844 17.765 12.2423 13.0376 -22.9613 11.2697 +208 1 11.5498 10.1018 4.11619 27.4262 20.5676 -21.0421 +209 2 11.5687 10.5955 3.24216 -3.20948 -18.7647 28.9446 +210 2 12.4899 10.1059 4.45555 -29.515 -1.53007 -14.7279 +211 1 8.38254 12.182 3.76573 -26.3924 1.04105 6.81072 +212 2 9.25863 12.501 4.06076 -19.5654 3.48754 6.33549 +213 2 7.63736 12.4251 4.40785 41.4561 -5.4387 -17.0092 +214 1 14.3228 4.03714 3.29709 11.5996 0.889358 18.0886 +215 2 14.8928 4.14179 4.10547 -12.6664 -0.432988 -23.901 +216 2 13.4701 4.45558 3.48891 5.46089 -2.24129 3.2962 +217 1 5.58188 1.78199 7.50513 -33.666 -46.5708 42.0626 +218 2 5.0172 1.13958 8.12095 34.1345 40.5367 -42.64 +219 2 5.33078 1.59122 6.59529 1.4651 -1.13721 -3.53311 +220 1 17.9086 1.12503 4.88467 5.13037 -2.27617 -10.7476 +221 2 18.4038 1.54032 4.14207 -7.55128 -2.38968 19.1857 +222 2 17.6814 1.78344 5.55455 5.62983 -0.00428508 -6.93418 +223 1 6.83101 9.39303 4.49716 -12.9019 3.06885 -29.4929 +224 2 6.83675 9.57499 5.42715 5.2276 -1.57178 18.8103 +225 2 7.66807 8.99049 4.24996 8.60683 3.06936 7.19189 +226 1 2.71406 14.9654 1.962 -12.6433 -7.2797 -26.4735 +227 2 3.33343 14.7912 2.66354 11.3685 -5.36414 4.18623 +228 2 3.09502 14.6645 1.10257 -3.50464 10.9487 24.1748 +229 1 17.279 12.8803 13.1283 -18.5839 20.1434 9.0108 +230 2 16.4044 13.2339 13.3283 -9.51346 -21.2442 0.20606 +231 2 17.6948 13.7346 13.0834 29.6252 3.29486 -10.2855 +232 1 15.0196 10.5818 1.38314 -38.8036 -34.5801 -31.952 +233 2 15.5102 11.1963 1.85791 33.5109 39.8843 28.1173 +234 2 14.3351 11.0964 0.933298 4.14202 -6.46403 5.49191 +235 1 5.71789 6.95838 4.52856 4.11089 -29.6335 9.96606 +236 2 5.85266 7.87985 4.34179 3.17266 16.1428 1.23553 +237 2 6.44364 6.70841 5.13514 -12.5329 -0.461157 -7.94794 +238 1 8.12142 8.26262 10.159 -0.855146 6.49391 46.4818 +239 2 8.58519 8.93965 9.66877 4.4396 1.59282 -10.2318 +240 2 7.56021 7.74854 9.59836 -7.32825 -5.6782 -22.3885 +241 1 13.5311 18.2901 5.8079 -14.4364 -13.815 12.5854 +242 2 12.703 0.102298 5.56963 8.23181 2.14052 6.61043 +243 2 13.2939 17.6289 6.50758 2.60691 23.7973 -17.1373 +244 1 0.327324 2.56344 0.113251 2.62118 15.3541 1.11187 +245 2 18.009 2.52214 18.5736 10.3638 17.1812 4.70476 +246 2 0.724331 3.48299 0.160564 -23.8753 -26.7718 -0.881277 +247 1 12.6396 10.9599 9.76875 -60.0152 14.8867 -10.4701 +248 2 11.6552 10.7306 9.75031 40.0232 26.8927 -4.84212 +249 2 12.944 10.1383 10.0842 28.9404 -31.8014 10.6031 +250 1 0.789377 12.2851 11.08 12.3121 4.77193 16.7259 +251 2 18.4919 12.3017 11.2021 -18.2956 -1.72231 -7.06107 +252 2 1.09088 12.7637 11.8722 5.11265 -11.1183 -7.6011 +253 1 5.04567 7.2193 13.4912 -20.9717 -2.87687 -14.2941 +254 2 5.59899 7.84649 13.0247 8.94565 11.9067 4.64647 +255 2 5.48047 6.97898 14.3058 11.2978 1.34955 6.76892 +256 1 1.28609 6.99027 11.837 -50.3798 -70.0072 -12.7986 +257 2 0.481329 7.14037 11.2978 16.1889 0.462756 10.6855 +258 2 1.71601 7.79102 11.8803 28.8555 60.7949 7.07409 +259 1 15.4442 9.46712 12.3088 17.5488 35.5581 30.8368 +260 2 15.6103 10.4448 12.4444 -11.4156 -32.7422 -13.7105 +261 2 15.5582 9.10301 13.208 -6.0251 -0.167312 -17.6616 +262 1 16.6404 12.9744 5.44078 -0.477448 -16.7093 5.71929 +263 2 16.2955 13.8866 5.54247 6.71099 -18.3284 -17.4666 +264 2 16.51 12.593 4.54035 -5.5475 22.5864 15.6708 +265 1 6.17495 10.0683 0.210584 -22.0037 -7.52033 -29.8636 +266 2 5.35839 10.4511 0.557392 5.20282 -1.85407 -1.83494 +267 2 6.76092 10.0813 0.943985 23.8798 0.550264 15.5383 +268 1 12.3644 6.05734 4.04236 -20.6788 -35.4367 28.6454 +269 2 12.4738 6.70802 3.38308 -3.94744 31.282 -24.9442 +270 2 11.4212 5.77124 4.03221 20.7152 8.11174 -1.23853 +271 1 0.124733 12.8266 0.203961 1.72956 2.54106 -4.3392 +272 2 0.029974 13.5935 0.786871 -3.06107 -4.47794 0.0529132 +273 2 18.185 12.9963 18.0877 7.84157 1.57112 5.96497 +274 1 3.83931 18.5785 8.61972 17.9182 -8.56599 -14.1766 +275 2 3.58625 18.36 7.70531 -6.70328 -0.941099 8.10721 +276 2 3.07994 0.282626 9.06556 -18.5101 7.20519 -0.527908 +277 1 7.37599 17.2741 4.45241 45.8101 34.7343 -2.7797 +278 2 8.02493 17.9603 4.76808 -26.0663 -25.3607 -1.65849 +279 2 7.47725 17.3636 3.49301 -12.8678 -9.31687 6.18264 +280 1 9.20909 17.0315 12.2197 44.1268 -5.71549 17.0535 +281 2 9.48765 16.172 11.8421 -16.3435 15.6721 -2.29993 +282 2 9.99892 17.2887 12.7762 -25.7988 -5.61825 -13.0657 +283 1 13.3284 13.0292 7.94175 -52.6762 -33.6944 -6.73328 +284 2 13.0533 12.253 8.47808 14.3801 9.17086 -2.06391 +285 2 14.1985 13.2855 8.14946 32.3912 12.3835 13.183 +286 1 14.9871 2.94126 15.3478 14.7752 10.8142 -9.8874 +287 2 14.2243 2.52816 14.9303 6.27209 -7.10728 -1.53608 +288 2 15.7054 3.02501 14.6718 -21.9622 -5.02255 13.6584 +289 1 9.85637 15.4939 17.0026 6.25802 5.34328 -5.30261 +290 2 10.2013 14.6312 16.7411 3.93948 4.67059 -1.18803 +291 2 9.35728 15.3668 17.8085 -8.94372 -2.90673 5.88613 +292 1 11.2848 8.23994 16.5492 3.15289 33.2939 2.2253 +293 2 10.8315 7.75123 15.8747 -9.91387 -14.5897 -7.3255 +294 2 11.7506 7.62533 17.1016 4.32393 -13.5731 6.91104 +295 1 3.77097 18.1898 16.7118 5.96936 32.6304 11.943 +296 2 4.24576 17.6768 17.3569 8.77088 -19.0197 5.38959 +297 2 3.7978 0.441972 17.1008 -3.8528 -14.6362 -12.0582 +298 1 2.20581 4.09889 8.95874 4.57905 1.19328 9.26631 +299 2 3.00197 3.55544 8.74643 -17.2537 17.4622 14.7611 +300 2 2.10364 4.24367 9.94001 11.4926 -15.28 -28.3391 +301 1 9.9196 10.3581 9.75231 -27.966 16.15 -17.0738 +302 2 9.34403 11.1055 9.40387 24.0849 -21.7639 18.0289 +303 2 9.87032 10.282 10.7171 1.16507 9.52838 -7.01624 +304 1 9.73405 0.807167 10.8572 18.2139 21.6835 4.91261 +305 2 9.58177 18.5811 11.2204 -14.9491 -12.8069 -2.84973 +306 2 9.10878 1.03014 10.1675 -9.37034 -6.01821 -3.77915 +307 1 9.18221 15.2247 10.2123 -19.1642 -10.2407 -19.6365 +308 2 9.04674 16.0847 9.7631 0.663926 -17.4388 12.4081 +309 2 8.3908 14.6843 9.94105 22.9839 14.6501 17.4764 +310 1 1.00316 9.27987 10.329 14.3691 -27.2472 -11.0896 +311 2 1.16727 10.1904 10.5724 12.779 8.1681 -2.56256 +312 2 1.84996 8.76119 10.1498 -30.7163 35.51 10.5854 +313 1 16.8004 4.89338 8.19813 23.5039 -12.6505 29.7165 +314 2 16.1748 5.31624 8.83318 15.8467 -9.35353 -17.5774 +315 2 17.4877 4.38941 8.71628 -29.2517 16.802 -13.3541 +316 1 14.6379 14.6893 0.402347 -11.159 -0.978579 14.7724 +317 2 14.9609 15.3376 1.05877 0.0769081 -12.0935 -6.53519 +318 2 13.9048 14.1906 0.841144 15.9383 15.9909 -14.4014 +319 1 3.51181 11.0525 9.63829 2.1739 12.5105 -11.7746 +320 2 3.41507 11.3617 10.5484 4.86707 2.92948 -3.5212 +321 2 3.25155 11.8076 9.06383 -0.0479228 -15.275 7.06779 +322 1 11.0289 10.8695 1.26208 17.169 21.0662 -6.34954 +323 2 11.1535 11.716 0.753779 -4.03889 -27.9068 14.1765 +324 2 10.1142 10.5923 1.16471 -3.02205 2.54599 -1.38039 +325 1 13.2239 7.06188 12.8977 -30.3793 3.52384 -4.06516 +326 2 14.1381 6.84046 12.8922 25.6531 -5.59605 1.27225 +327 2 12.7471 6.22139 12.9668 3.13335 6.34025 -4.15647 +328 1 9.62584 1.88878 0.937813 20.0839 -1.09549 37.2578 +329 2 8.77484 2.11506 0.623903 -26.2152 1.3675 -15.013 +330 2 10.1764 1.70882 0.191067 9.10224 -0.512606 -16.4895 +331 1 10.6054 13.537 4.7508 -3.45661 -5.20977 -1.23778 +332 2 11.3208 12.9359 5.04367 -5.78837 16.6981 -6.98771 +333 2 10.4128 14.1619 5.47507 11.2154 -13.4565 -5.70688 +334 1 14.2525 1.6915 10.8868 25.1006 21.2848 4.13062 +335 2 15.0842 1.26497 10.6465 -4.75627 -8.22365 -3.1417 +336 2 14.5069 2.62992 10.8824 -13.5101 -4.08816 2.36647 +337 1 14.6678 12.4248 11.7157 -12.7858 -12.3306 -9.5252 +338 2 15.5574 12.5766 11.3177 -24.032 -11.5318 -4.29299 +339 2 14.0022 11.9667 11.1187 32.4402 16.632 10.9337 +340 1 8.24065 5.08218 9.78509 -7.81525 41.6802 29.5679 +341 2 7.45364 5.10173 10.3836 16.236 -11.1581 -20.3292 +342 2 8.36822 4.22882 9.41503 -10.4798 -31.0118 -7.50393 +343 1 1.59893 16.8132 18.3262 1.78713 43.6046 -19.4726 +344 2 1.99225 17.1675 17.4932 -13.4068 -2.95443 18.1753 +345 2 1.72693 15.8931 18.2458 9.12037 -33.6792 3.80865 +346 1 1.43382 17.2563 15.3383 70.3372 -10.1908 -13.5082 +347 2 1.32309 18.1562 15.5759 -5.39176 26.6374 11.2222 +348 2 0.623143 16.841 15.3782 -64.6751 -20.2725 0.847241 +349 1 3.73599 5.55499 6.2196 -13.8181 39.8005 -2.84681 +350 2 3.32092 6.26594 6.76194 2.21889 -20.7758 -8.723 +351 2 4.19567 6.05321 5.52665 5.67395 -4.434 2.61268 +352 1 12.357 9.41487 14.1826 15.3987 -29.3966 1.09302 +353 2 12.9591 8.63784 13.9021 -33.8501 34.209 16.2235 +354 2 11.936 9.15457 15.0346 16.6427 1.77305 -15.4117 +355 1 4.0362 15.2647 6.90572 33.8672 24.728 -7.08093 +356 2 3.45744 16.0249 6.7945 -6.17655 -1.99751 -5.28974 +357 2 4.92941 15.6518 6.66696 -29.006 -22.9584 9.78444 +358 1 0.606517 8.56128 14.8606 9.39684 15.8059 -8.30397 +359 2 0.498099 9.52604 14.9437 -1.87135 -9.61679 5.58044 +360 2 1.28855 8.50016 14.167 -9.83185 -6.21013 7.33103 +361 1 12.9763 8.3683 10.3434 1.19405 4.03237 -29.9304 +362 2 13.7163 7.90436 9.89822 -7.22584 1.47622 17.5396 +363 2 12.9003 8.0957 11.2534 8.23718 -11.529 10.7869 +364 1 15.2983 7.63672 3.47583 -36.323 -26.5913 31.5529 +365 2 14.5024 7.10501 3.29647 15.7237 15.5958 -25.1442 +366 2 15.2922 7.47095 4.43335 26.8259 14.207 -3.84044 +367 1 17.3208 6.63818 0.028906 -16.9884 17.5938 -6.80353 +368 2 16.7479 6.05403 0.554933 4.15554 3.30118 -7.73843 +369 2 16.7141 7.27151 18.2009 11.1968 -20.2911 18.275 +370 1 8.79355 6.92545 7.84172 -17.9944 -26.8715 17.7017 +371 2 9.63968 7.32585 7.85068 34.0918 14.4557 -5.0304 +372 2 8.77688 6.39871 8.67404 -5.99252 8.25367 -18.4431 +373 1 12.3209 0.607808 1.1741 -9.70621 -1.67076 -6.18378 +374 2 12.995 1.15082 1.58835 11.8921 -6.95349 3.94176 +375 2 12.79 18.5825 0.66073 -1.23695 5.23567 5.50046 +376 1 5.68514 15.097 14.5145 3.67475 30.0662 -16.0184 +377 2 4.72797 15.1695 14.4772 -3.92865 -1.97247 7.85561 +378 2 6.02476 15.8935 14.032 -4.97132 -21.5573 17.6103 +379 1 3.822 6.53853 1.67803 9.4136 -3.73603 -11.0507 +380 2 3.54968 7.33117 1.17576 -2.2757 -10.4776 17.1213 +381 2 3.81642 6.7886 2.60252 -0.785086 8.11893 4.5328 +382 1 3.89262 11.6088 12.227 13.3033 3.31132 5.82178 +383 2 4.72051 12.1032 12.348 -1.72331 -9.21471 -1.78635 +384 2 3.26281 12.0921 12.7526 -14.3078 7.33513 5.3451 +385 1 5.45444 3.88172 15.8755 10.9934 63.7886 22.8921 +386 2 5.90627 3.24049 15.3708 25.1493 -29.4334 -15.1609 +387 2 6.11665 4.65725 15.9739 -37.1513 -37.4972 -5.17498 +388 1 14.4636 10.317 4.39501 8.04256 -17.7362 -43.5508 +389 2 14.9051 9.88853 5.13417 -2.05112 -4.59794 0.583625 +390 2 14.7084 9.81768 3.53446 -13.0506 20.827 46.8358 +391 1 7.94949 17.2895 9.24469 -12.4073 10.6503 -4.49958 +392 2 7.23447 17.5423 9.86969 11.4984 0.663317 -18.2334 +393 2 8.01085 17.8889 8.47627 -8.74254 0.310971 13.2931 +394 1 4.4986 14.4237 3.96317 22.7921 6.59984 27.2073 +395 2 4.89523 15.3318 4.14709 -15.7294 -33.8816 -1.82578 +396 2 4.80237 13.7713 4.67129 -10.4496 32.1184 -24.135 +397 1 14.3358 7.38467 15.7635 24.4704 6.70756 7.84838 +398 2 15.2401 7.23754 15.391 -26.2451 3.74497 13.7384 +399 2 14.4998 7.83446 16.6232 -7.00308 -11.7114 -18.5693 +400 1 2.86875 18.2246 1.90934 8.22952 29.9251 46.5059 +401 2 2.54447 17.7626 1.17928 -17.7355 -34.6574 -39.0362 +402 2 2.08284 18.4154 2.45796 15.223 4.61378 -9.70941 +403 1 7.96139 1.61197 4.52525 29.4796 -3.5692 28.5612 +404 2 7.4985 1.83317 3.72811 -4.47294 12.8461 -13.1797 +405 2 8.84188 2.051 4.57628 -23.8244 -8.06079 -10.6756 +406 1 2.69247 14.1251 17.7583 -39.7925 -12.5472 14.0506 +407 2 1.78944 13.8074 18.0556 30.3506 3.26472 -13.0537 +408 2 3.33089 13.517 18.1683 -2.67461 8.7222 -7.81087 +409 1 0.711797 1.68055 13.8626 44.8563 0.102291 -15.8697 +410 2 0.854596 1.56791 14.7929 -2.34617 -4.64243 17.7358 +411 2 18.4557 1.86826 13.7064 -36.5874 5.33291 1.35002 +412 1 4.5582 18.5986 13.9691 17.69 -10.1212 -17.3986 +413 2 5.37614 18.0918 13.7297 -17.5363 18.7277 11.6893 +414 2 4.4096 18.4453 14.9034 -4.80692 -4.44744 5.40837 +415 1 7.10973 0.453475 18.3742 -17.6731 43.6393 33.9394 +416 2 6.99644 0.098599 17.5235 3.55611 -15.5456 -38.0778 +417 2 6.34312 1.05085 18.5323 11.5496 -19.3687 -0.295067 +418 1 16.0934 18.4421 14.1505 -13.5696 -24.3411 -34.6818 +419 2 15.444 17.7866 13.7542 20.5302 26.3107 23.9987 +420 2 16.0379 18.4915 15.109 -11.2087 -0.403296 -0.42938 +421 1 10.1156 4.52417 16.2956 -63.5341 -10.6596 -28.1335 +422 2 10.9808 4.34247 16.5381 54.6034 1.03427 17.4186 +423 2 9.84863 3.69679 15.8473 1.5569 12.8802 9.55133 +424 1 15.8226 17.9425 4.41327 -12.7412 7.89699 33.5898 +425 2 16.5547 18.5732 4.53052 -9.15632 -3.64108 -2.38506 +426 2 15.1071 18.2295 5.06915 28.1993 -15.1976 -35.9746 +427 1 6.9246 17.3574 13.7412 41.9162 15.5861 -1.52717 +428 2 7.49648 17.8115 14.4369 -23.1807 -22.4309 -23.3681 +429 2 7.52703 17.1963 12.9658 -13.588 5.84324 25.6525 +430 1 13.2892 6.57209 6.73437 -45.0771 -7.84691 9.23056 +431 2 14.2146 6.66317 6.83486 35.9508 1.69852 -11.4068 +432 2 13.0394 6.38579 5.82242 8.43649 1.47489 -3.25235 +433 1 7.6616 2.3861 9.17526 8.07841 -8.24756 -37.8228 +434 2 7.32169 2.39592 10.0555 -17.554 -3.79201 20.6206 +435 2 6.95914 2.1022 8.53308 18.9972 7.96045 22.8376 +436 1 15.1464 14.8771 13.6482 -9.08859 5.19149 1.30171 +437 2 15.0308 15.0223 14.6069 -2.64384 -0.244686 -12.5428 +438 2 14.3194 15.1152 13.1798 15.9342 -4.32482 12.4068 +439 1 9.29105 8.34315 3.70472 25.3147 -22.6228 7.1656 +440 2 10.1776 8.75859 3.73678 -14.6049 0.788849 -0.227964 +441 2 9.48378 7.39942 3.88081 -7.38963 16.6026 -2.51653 +442 1 17.6854 13.4687 16.4528 1.20699 34.422 -16.619 +443 2 16.7357 13.4337 16.3398 -3.15338 -8.61752 5.60033 +444 2 17.8844 14.3284 16.0065 4.30498 -21.0483 11.9174 +445 1 5.04883 10.6547 2.58751 21.171 -14.0773 3.70172 +446 2 5.87017 10.3468 3.04382 -23.0848 5.17759 -4.78185 +447 2 4.55197 11.1441 3.22928 -5.68041 9.33128 13.9497 +448 1 3.70566 8.3683 10.3381 2.8322 -31.099 -4.13864 +449 2 3.86061 9.29726 10.2176 3.71195 18.7597 0.626964 +450 2 3.86652 8.14601 11.2715 -4.70232 11.1023 -9.34814 +451 1 16.1079 7.11641 6.33859 19.1617 -15.4194 -14.8444 +452 2 16.7241 7.70559 6.80408 -7.69122 -6.37409 -7.38138 +453 2 16.6678 6.33083 6.12136 -24.1396 12.8226 8.63966 +454 1 15.2027 7.00502 9.1117 -12.4455 33.5656 -30.1004 +455 2 16.009 7.42176 9.46585 -11.7729 -5.93044 -7.51071 +456 2 14.9881 7.51375 8.25647 14.3105 -22.443 40.0586 +457 1 6.4525 13.1649 12.9201 -14.4212 4.62434 6.2224 +458 2 7.2977 12.7289 13.0561 -0.519457 -3.7562 7.19322 +459 2 6.25327 13.7237 13.7059 9.03992 -10.4089 -22.4145 +460 1 12.1145 4.49786 13.0694 60.1541 40.3897 -0.599702 +461 2 12.3852 4.68406 13.9868 -12.8154 -8.572 -1.53547 +462 2 11.3952 3.9317 13.0199 -51.9002 -33.7145 4.15206 +463 1 11.3323 8.18365 7.8522 33.2694 0.481688 12.7059 +464 2 12.0901 7.73501 7.43634 -16.2057 -1.97452 -6.97761 +465 2 11.7651 8.45102 8.68662 -20.5523 -0.0583287 -5.01537 +466 1 17.1666 10.776 7.42179 36.6255 -17.1838 -28.5238 +467 2 17.7906 10.0723 7.08441 -19.5131 16.2155 23.227 +468 2 17.2793 11.4524 6.73733 -13.1225 1.2547 8.82205 +469 1 5.22802 18.1471 11.05 -26.218 -15.3265 2.15414 +470 2 4.73762 18.1049 11.901 9.27461 0.443739 -18.2338 +471 2 4.62535 17.7417 10.374 18.9971 14.5949 15.121 +472 1 7.56653 17.6363 1.80821 2.05543 -3.48119 51.3305 +473 2 7.65741 16.7768 1.42856 8.63412 -18.3953 -16.9352 +474 2 7.35855 18.2549 1.13994 -1.30452 14.3677 -27.7338 +475 1 1.85092 12.9256 13.6076 17.4877 19.0754 23.2488 +476 2 1.72104 12.4156 14.4258 -6.17153 0.259213 -13.4945 +477 2 2.19932 13.7866 13.9501 -9.51965 -23.6336 -9.57422 +478 1 9.73868 6.79159 14.8001 -20.4051 42.5069 -0.796717 +479 2 9.95236 5.95211 15.1529 11.7083 -38.3225 9.01974 +480 2 9.967 6.84408 13.8723 6.06139 -4.97285 -7.43337 +481 1 15.2087 4.3972 10.7794 -26.9028 -24.0998 -25.0358 +482 2 16.0082 3.89203 10.8637 24.0661 5.32644 6.50358 +483 2 15.2102 5.16148 11.3322 8.70888 13.5856 17.3899 +484 1 11.1963 6.12482 0.150068 -24.122 -22.6006 13.7234 +485 2 11.2381 5.20796 0.481504 11.6671 13.7026 -10.2768 +486 2 10.2374 6.21547 18.6186 16.3103 12.5014 -3.12394 +487 1 0.19533 11.3359 15.1413 -21.6592 10.769 -30.7731 +488 2 18.4021 11.874 14.3993 14.4722 -20.1415 31.2795 +489 2 18.4481 11.661 15.9631 4.68348 9.49999 -5.94609 +490 1 7.06882 9.13032 7.26059 -22.6631 -3.09615 15.424 +491 2 6.55985 8.40099 7.69941 15.0645 18.9564 -17.5163 +492 2 7.9725 8.82922 7.21375 6.85038 -6.33336 0.902711 +493 1 18.4578 15.4507 12.3537 6.97015 0.808933 -7.22971 +494 2 0.776651 15.5698 12.2511 -16.5258 -3.56518 7.28193 +495 2 18.1456 15.6789 11.4721 -4.11121 -1.28038 2.68538 +496 1 16.5694 4.36967 5.25107 2.45626 -29.8761 41.2812 +497 2 16.7744 3.81151 6.06026 -19.4928 29.4804 -23.4548 +498 2 17.3898 4.32671 4.78168 14.6436 6.44337 -19.6343 +499 1 17.788 3.06911 10.7078 8.19486 16.3181 17.0759 +500 2 0.075758 3.1322 11.0257 -18.3141 -4.46618 -10.1687 +501 2 17.6332 2.20749 10.3226 7.04824 -10.7221 -5.22745 +502 1 12.3142 0.064083 10.1758 -16.6046 52.5698 5.40656 +503 2 11.3746 0.384648 10.259 27.2889 -19.3162 -0.832384 +504 2 12.8178 0.919304 10.3228 -10.5773 -40.3011 -9.47381 +505 1 10.3666 9.83315 12.2981 15.5663 4.35939 24.9446 +506 2 11.1015 9.85063 12.955 -12.9587 3.49885 -14.3711 +507 2 10.1328 8.91188 12.2898 -2.48305 -14.5784 -4.85859 +508 1 0.463654 2.82678 7.01839 21.5285 29.229 11.0876 +509 2 0.875324 3.58845 7.48211 -15.1018 -9.47019 -10.8481 +510 2 0.770257 2.12665 7.58365 -2.10845 -18.3887 2.87796 +511 1 0.478371 15.2358 6.91004 -5.05906 -57.415 8.40739 +512 2 0.585298 15.6463 7.75647 1.85019 10.3725 13.8373 +513 2 0.556531 14.2524 7.18353 -2.63305 52.383 -27.2731 +514 1 16.9534 7.00251 15.3394 -15.9191 6.08615 -6.45156 +515 2 17.6338 7.63543 15.0899 14.1822 -6.8729 3.83609 +516 2 17.3093 6.19568 15.7235 10.8839 2.85836 -7.52482 +517 1 9.0001 12.4151 8.13768 -31.1102 30.9609 25.8163 +518 2 9.37386 11.8218 7.49742 -5.17233 -14.4246 -22.3971 +519 2 8.02402 12.632 8.03373 38.2843 -19.0142 -6.47162 +520 1 1.27238 1.95406 3.05803 -13.5483 -7.94682 -18.4152 +521 2 1.26084 2.61511 2.34121 0.274888 -9.5029 12.9388 +522 2 1.89031 2.22344 3.73293 6.76618 11.1556 -0.474465 +523 1 4.13907 15.1156 9.62039 -21.6353 8.89781 12.928 +524 2 4.07003 15.1439 8.65747 6.73796 -2.17255 1.87071 +525 2 4.96029 14.7006 9.86457 13.8731 -5.89958 -3.36363 +526 1 7.17628 2.17866 14.5671 10.1969 15.6665 0.500505 +527 2 6.99528 1.68402 13.7698 -5.58163 -4.27811 -6.1139 +528 2 7.62131 2.98432 14.249 -3.31044 -9.5634 8.35677 +529 1 18.6082 14.7131 2.1481 32.6395 -16.0207 -3.46113 +530 2 0.838003 15.1297 2.25966 -5.15041 -8.02703 -3.38947 +531 2 17.988 15.3544 2.42675 -27.9684 22.1971 4.74449 +532 1 9.94138 2.79524 12.9422 16.7157 -19.9527 -5.96647 +533 2 9.79404 2.1456 12.2228 -2.63367 12.9584 8.66897 +534 2 9.17835 3.36299 13.0326 -7.96092 5.51528 -6.54514 +535 1 2.80444 8.90955 13.0076 -17.7822 -13.1167 0.317539 +536 2 3.06361 9.80599 12.872 10.5962 22.9278 -4.25378 +537 2 3.5122 8.48618 13.4775 15.1932 -9.60442 7.00981 +538 1 3.236 8.3574 3.63664 -2.86765 -22.2709 68.2353 +539 2 3.45085 9.0718 3.07326 14.564 28.9211 -13.7717 +540 2 3.47645 8.58669 4.60794 -11.4307 -4.68562 -51.1711 +541 1 5.62853 7.18594 8.51094 8.63755 21.4894 2.16978 +542 2 5.46784 6.31815 8.13889 -3.95344 -9.53044 10.3317 +543 2 4.96415 7.47792 9.15047 -3.24726 -12.0183 -2.29801 +544 1 14.8757 1.26039 2.01768 8.95967 6.82752 -28.1452 +545 2 14.9353 2.01952 2.56559 -6.40438 15.8227 28.9683 +546 2 15.2784 1.60993 1.21235 -4.35761 -14.1118 -5.79377 +547 1 8.22892 15.2012 0.850139 10.8537 -12.6178 7.38979 +548 2 9.02213 14.9338 1.33488 2.38301 14.3333 -0.830013 +549 2 7.55366 14.6663 1.27665 -9.08858 2.03607 -6.2405 +550 1 15.6387 1.34587 7.23673 -38.2068 -12.1482 -8.38322 +551 2 14.9277 0.724731 6.91269 26.6184 17.4884 8.18161 +552 2 15.1173 2.1119 7.53894 10.4663 -3.86302 -4.52487 +553 1 4.90142 13.0959 18.5232 17.6249 -4.01801 23.9701 +554 2 5.32755 13.082 0.76977 -10.7656 0.632793 -19.6876 +555 2 5.44764 13.7122 18.0259 0.499955 -3.74815 -4.96885 +556 1 15.3368 8.46948 18.1479 21.2409 26.352 -19.7425 +557 2 15.8061 9.12264 17.5623 -15.5364 -21.5252 11.6976 +558 2 15.3318 8.91689 0.353875 -5.84476 0.442576 5.05054 +559 1 12.0708 3.01842 18.3809 -8.91332 38.2285 -17.9492 +560 2 11.9316 2.65996 0.60646 7.08072 -18.979 4.32412 +561 2 12.6022 2.47389 17.7995 4.78982 -18.1658 8.07002 +562 1 13.2139 12.6752 5.17768 -9.57044 10.0795 -9.57129 +563 2 13.7464 12.0348 4.69253 1.60656 -5.44915 8.62561 +564 2 13.2564 12.5123 6.11793 10.4898 -3.48459 7.66387 +565 1 6.05443 7.0356 0.031519 0.0605761 -19.9038 6.17744 +566 2 5.93935 7.95118 18.5019 3.71712 34.2187 -1.98634 +567 2 5.39095 6.86665 0.702638 -7.83388 -10.1683 0.476271 +568 1 17.7528 16.0276 15.0213 -25.9758 6.2762 6.79882 +569 2 16.9476 16.5457 15.105 3.54626 -1.67183 20.5845 +570 2 17.7479 16.0055 14.0813 22.8568 -13.146 -30.1028 +571 1 13.196 0.994907 16.5363 6.37162 1.07879 13.9702 +572 2 14.1481 0.997912 16.7614 -14.4757 -4.73392 -6.84542 +573 2 12.8833 0.094199 16.7238 3.07394 5.84273 -8.05351 +574 1 11.1253 14.5647 7.20271 13.6513 20.7581 -19.5035 +575 2 10.4007 14.3183 7.72981 -32.979 -9.13798 24.3252 +576 2 11.7186 13.8255 7.26943 15.8912 -3.80541 2.99114 +577 1 17.5081 8.62849 2.08107 17.5857 37.593 18.6886 +578 2 16.6801 8.63471 2.55495 -11.5266 -11.0229 1.73392 +579 2 17.5233 7.88242 1.516 -4.85302 -28.502 -20.2632 +580 1 12.3547 8.01168 2.02213 2.8693 7.47745 -2.1033 +581 2 12.2384 8.8582 1.54611 -1.5199 -14.1485 9.25757 +582 2 11.9739 7.3152 1.48261 -4.60849 0.564674 -12.802 +583 1 11.8761 14.6165 10.3364 -1.28632 -27.1744 -11.0444 +584 2 12.1004 13.7873 9.81464 -15.5434 34.4502 21.6186 +585 2 10.8993 14.6888 10.473 22.8986 -6.0814 -12.7032 +586 1 6.89524 7.05211 15.6117 2.70483 5.93472 10.8866 +587 2 7.81004 7.26536 15.3122 -19.1207 -0.823892 9.8847 +588 2 6.66676 7.54167 16.4408 15.3743 -10.0989 -25.4065 +589 1 8.00326 4.73593 13.4743 46.2088 18.1039 21.0673 +590 2 7.23337 4.7302 12.9572 -37.1051 2.19442 -26.1447 +591 2 8.40671 5.62958 13.343 -9.63909 -26.9075 5.20654 +592 1 13.4128 12.1818 14.2522 -5.46405 -2.8504 7.05596 +593 2 12.9414 11.3292 14.2657 10.1901 3.29349 -5.65079 +594 2 13.7875 12.315 13.3696 -1.58979 -2.51674 3.72795 +595 1 14.8395 9.42189 7.30548 -10.1492 -33.0314 -14.9507 +596 2 15.7087 9.765 7.42505 18.3001 17.1245 4.25051 +597 2 14.2269 10.0768 7.57319 -16.3703 19.68 11.0075 +598 1 12.6526 17.0686 3.07252 -25.5483 38.6692 13.4046 +599 2 12.8376 17.5237 3.93373 3.7914 -19.7635 -24.6942 +600 2 11.9913 17.6958 2.63477 29.3498 -30.5169 14.5322 +601 1 1.15545 7.13838 17.4647 -1.30818 10.8795 -24.4228 +602 2 0.330359 7.36323 17.9184 3.51096 -10.352 -1.0007 +603 2 1.05514 7.47868 16.5422 2.6229 -4.15873 21.1004 +604 1 12.7562 5.15096 15.6457 46.9745 -3.15458 16.4241 +605 2 13.4512 4.55662 16.0315 -23.8856 11.8204 -16.5269 +606 2 13.2414 6.00335 15.5788 -13.869 -10.6853 0.37407 +607 1 2.53993 3.38757 4.97618 -24.4059 44.0626 48.9955 +608 2 1.7609 3.18232 5.58922 29.5313 1.39757 -24.0522 +609 2 2.84154 4.31546 5.27885 -6.94106 -48.8689 -12.2378 +610 1 8.33186 11.2983 13.4548 -25.447 4.99647 44.923 +611 2 8.4244 11.0562 14.4444 7.04045 1.38295 -54.395 +612 2 8.91168 10.8786 12.8197 20.7237 -12.5345 14.2107 +613 1 12.8689 1.31514 13.3384 4.70567 59.9078 -15.5432 +614 2 13.42 1.58034 12.5659 -9.46235 -19.1343 13.2352 +615 2 12.4231 2.17844 13.5496 8.70338 -32.6779 -3.58081 +616 1 6.34008 13.7169 2.14963 -19.3306 -6.11379 22.757 +617 2 5.63978 13.877 2.82959 17.9638 4.85668 -21.8758 +618 2 6.88351 13.0442 2.56282 8.57629 -2.48731 -1.94932 +619 1 15.9206 6.61444 12.7992 -23.3103 -26.3741 2.68057 +620 2 16.3106 7.25195 12.2393 16.9755 20.6681 -18.7226 +621 2 16.4213 6.59661 13.608 7.79648 1.05266 12.4236 +622 1 16.8298 0.712824 9.59482 4.79811 -22.8344 -3.47194 +623 2 16.8791 18.3713 9.72616 -6.98639 26.8255 -1.99774 +624 2 16.5452 0.8605 8.67269 -2.39382 -2.67689 10.2173 +625 1 6.14624 11.7631 8.37671 0.189841 -56.9827 6.97012 +626 2 5.32447 11.4591 8.84151 16.7156 13.8425 -13.046 +627 2 6.64226 10.8931 8.20176 -19.0535 39.3101 2.14415 +628 1 2.88754 8.61261 0.453821 12.2401 -11.553 -23.675 +629 2 2.45212 8.04764 18.3917 -4.84247 31.247 26.7064 +630 2 2.34875 9.28564 0.895642 -13.4946 -8.81401 -13.4914 +631 1 10.1674 10.4623 6.50123 4.87464 -2.88608 -13.8248 +632 2 10.6087 9.69731 6.89122 -0.620763 2.00125 4.93232 +633 2 10.4694 10.4636 5.56932 -5.34739 2.02001 15.3519 +634 1 6.7142 15.6951 6.55167 22.995 7.84961 12.6004 +635 2 7.14328 16.1838 7.27089 -9.73558 -8.55589 0.364412 +636 2 7.21237 16.006 5.79102 -10.9792 5.43097 -10.3878 +637 1 6.445 13.1807 5.57797 -3.32019 -20.8794 2.06608 +638 2 6.7301 13.9465 6.07331 -1.80129 7.88671 5.96843 +639 2 6.09943 12.5433 6.22286 1.13913 6.90777 -2.85329 +640 1 16.8242 12.5629 9.83758 3.36613 -21.9924 0.476486 +641 2 16.9985 11.8651 9.16533 -5.29916 18.5903 6.02329 +642 2 16.5644 13.3844 9.42716 1.61266 3.35571 -10.8679 +643 1 6.03738 2.95058 2.86354 -7.51536 -24.4327 -2.00067 +644 2 6.40977 3.757 2.57075 14.9417 32.1903 -3.64532 +645 2 5.57703 2.61747 2.09059 -4.23441 -8.07329 -3.19257 +646 1 10.9114 3.33767 3.30112 3.4906 -2.16377 5.30702 +647 2 10.297 4.02722 3.58926 -1.61521 -6.66566 -5.52383 +648 2 10.5127 2.84524 2.57795 -5.77666 1.81375 -3.43243 +ITEM: TIMESTEP +10 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.68194 7.08301 17.95 -9.31723 -4.61569 5.17534 +2 2 7.78696 6.81626 18.2438 14.604 4.05464 -8.83536 +3 2 8.80373 6.759 17.0506 -2.23465 -3.10488 4.80291 +4 1 18.5422 8.2512 6.84005 -1.85374 20.2636 49.1182 +5 2 0.133718 7.9438 5.98823 13.4692 -17.0673 -32.1853 +6 2 0.402402 7.78616 7.5434 -4.29735 0.835788 -17.7519 +7 1 8.38516 18.5522 6.81414 18.1861 9.65042 -3.37417 +8 2 9.3349 0.126592 6.72298 -16.1755 -3.42506 1.43069 +9 2 7.92248 0.594936 6.31239 0.819355 -0.881225 3.09059 +10 1 6.59178 1.84314 11.71 32.0023 -4.98621 -11.2566 +11 2 5.89352 2.36713 12.0513 -24.1224 14.8358 13.0259 +12 2 6.19214 1.0378 11.3953 -8.69892 -12.638 -2.90229 +13 1 7.13386 5.75674 2.33026 -14.5408 0.616599 17.9391 +14 2 6.48306 6.1089 3.01881 22.5383 -2.3727 -34.6055 +15 2 7.09544 6.2305 1.47237 -10.8297 -1.47351 21.389 +16 1 16.2171 10.1491 16.1328 -28.1801 3.24526 14.6911 +17 2 17.0032 10.2274 15.6211 19.8027 8.68317 -10.1896 +18 2 15.8342 11.0337 16.2804 9.6716 -6.93987 -4.62354 +19 1 10.6069 15.0266 2.30703 -4.98248 -17.7421 -7.27467 +20 2 10.5595 14.4209 3.0573 0.524935 2.03122 3.93242 +21 2 11.0455 15.8043 2.63229 7.74565 12.2645 5.86516 +22 1 17.1614 8.24714 10.3877 8.07926 1.42828 6.48104 +23 2 16.5623 8.78009 10.9215 0.0316367 4.64377 2.31684 +24 2 17.9785 8.76022 10.2824 -6.97801 -4.40732 0.702868 +25 1 14.8935 15.8724 16.3278 20.2214 -7.01151 6.5945 +26 2 14.0152 16.2142 16.2283 -22.9266 5.478 3.03945 +27 2 14.9126 15.3591 17.1528 -4.85523 2.97165 -4.07838 +28 1 12.1655 13.3835 0.413391 7.36911 -14.3954 12.824 +29 2 12.1103 13.7323 18.1651 -6.85057 6.78658 -3.29346 +30 2 11.6807 13.9152 1.05851 -4.03153 8.23708 -7.75902 +31 1 9.27599 5.36662 4.05276 -29.4571 7.127 11.0843 +32 2 8.67176 5.26931 4.85064 22.4619 1.60875 -30.6294 +33 2 8.67539 5.53054 3.28716 9.26602 -4.36827 15.8404 +34 1 1.82909 4.27439 11.6483 -10.3032 26.7578 -2.81239 +35 2 1.73625 5.21877 11.9337 1.99226 -22.9368 -8.90994 +36 2 2.3645 3.83767 12.2983 6.89168 -8.93952 11.7704 +37 1 1.96701 6.83625 8.36791 0.700563 -10.6105 -3.76521 +38 2 2.46094 7.16371 9.10974 5.61647 13.7513 9.96296 +39 2 1.91553 5.8986 8.57777 -2.9792 -4.95164 -6.48224 +40 1 5.40472 4.39468 7.93775 -13.5219 -10.4794 -16.6571 +41 2 5.47247 3.43369 7.82443 4.19114 6.69916 9.09153 +42 2 4.75726 4.62849 7.24994 8.09624 5.59982 9.8174 +43 1 3.2394 2.92305 17.5474 -0.484589 33.1528 15.1222 +44 2 3.93082 3.31406 16.9898 -0.722116 -4.79924 0.441987 +45 2 2.93778 3.68549 18.1255 3.8058 -28.2307 -17.5498 +46 1 7.46921 5.27133 6.11017 -1.04832 -15.5011 48.3459 +47 2 7.90561 5.59719 6.92877 -0.90713 11.0324 -30.0179 +48 2 6.96076 4.54233 6.5205 0.0145083 12.7024 -20.8234 +49 1 9.7753 7.02229 11.9825 10.38 0.905424 28.7819 +50 2 10.3185 6.36588 11.5577 3.53671 -5.58238 -7.94156 +51 2 9.14507 7.32646 11.347 -14.6838 3.32198 -19.6076 +52 1 14.1071 3.54759 8.03608 -23.8038 4.02857 -21.7378 +53 2 13.5341 4.25359 7.68722 9.9361 -9.73972 0.838395 +54 2 14.4214 3.88758 8.85457 11.6 9.53944 21.926 +55 1 4.79933 17.2591 4.02624 -13.379 0.496236 -8.73431 +56 2 5.57386 17.851 4.10922 -16.5825 -9.69995 -7.24814 +57 2 4.20396 17.5018 3.27728 17.9024 3.63898 12.5287 +58 1 16.5033 16.6227 10.0525 8.55043 -2.52252 -17.4646 +59 2 16.0579 16.4137 10.8501 -12.2091 1.77219 28.6058 +60 2 15.9447 16.1927 9.39741 3.82195 1.69594 -5.2917 +61 1 1.95551 4.92482 0.485806 10.2127 4.96395 -0.662752 +62 2 2.54163 5.27617 1.19707 -10.7364 -3.48306 -18.9921 +63 2 1.87778 5.63364 18.4632 -0.0680824 -4.88148 10.5435 +64 1 11.8064 13.3616 16.2803 -11.2011 -32.854 -16.2783 +65 2 11.3068 12.5375 16.4476 0.201944 14.5536 10.5803 +66 2 12.2047 13.1237 15.424 4.38621 16.2025 8.43328 +67 1 10.1065 11.0626 16.9483 14.8798 -23.3813 0.89342 +68 2 10.5718 10.2022 17.1278 -15.1514 23.106 -6.44625 +69 2 9.22125 10.8281 16.6474 0.614925 -0.65596 2.44857 +70 1 11.7253 17.5378 13.4688 -9.94093 -22.0621 2.41868 +71 2 12.2582 16.9669 12.8891 0.443382 11.1567 2.15207 +72 2 12.0419 18.4322 13.3705 7.56806 8.72697 -4.32807 +73 1 6.34321 9.31538 12.2256 -11.115 -24.1278 -16.4431 +74 2 6.95505 8.9709 11.5438 -2.74015 10.4344 10.5225 +75 2 6.7633 9.99127 12.7388 17.4243 13.1424 4.46627 +76 1 16.2194 12.7233 2.70094 -4.61478 -5.953 2.95318 +77 2 17.0002 13.1906 2.44934 22.4693 3.83429 -6.00104 +78 2 15.5655 13.415 2.69545 -17.2672 7.42791 2.42646 +79 1 0.634553 12.563 5.85853 -28.5577 11.9856 -12.6208 +80 2 0.914444 12.5082 4.92832 1.43228 -1.32003 11.8657 +81 2 18.3286 12.8558 5.76638 29.2028 -10.3468 5.65715 +82 1 5.19236 16.3841 18.4962 26.3246 -0.931967 -7.14386 +83 2 5.89246 15.8922 18.0344 -14.3156 -2.38899 -1.49205 +84 2 5.72254 16.912 0.454606 -10.9177 5.22319 5.94171 +85 1 0.515157 7.6307 4.06432 40.0561 19.3507 -22.9165 +86 2 18.554 8.04388 3.41083 11.6748 -7.97607 10.9949 +87 2 1.4672 7.83805 3.73432 -48.6916 -7.92141 18.8197 +88 1 3.14333 8.89821 6.52388 -38.7347 7.47588 -5.16066 +89 2 3.55606 8.61579 7.33755 0.264066 -1.79724 4.80444 +90 2 2.15121 8.92424 6.67318 38.4004 -3.38228 -2.38687 +91 1 7.3156 10.3041 16.1747 -22.5262 4.44621 22.8692 +92 2 6.53394 10.4783 15.6406 9.03524 -0.350523 -4.2891 +93 2 6.93671 10.3234 17.0875 14.5541 -1.9474 -13.7178 +94 1 11.1094 1.06061 5.00017 -8.33223 -1.63593 -20.1003 +95 2 11.1653 1.90766 4.53999 7.02718 4.91961 9.72987 +96 2 10.7116 0.517103 4.29895 3.46448 -7.62041 12.1963 +97 1 4.44086 2.70257 13.2121 -8.76198 -6.25056 -12.8305 +98 2 4.61839 3.20254 14.0253 0.411253 -15.6801 0.294236 +99 2 4.37598 1.71769 13.3483 2.92355 28.3656 12.0639 +100 1 8.41481 10.0299 1.78755 2.58083 -12.9704 20.4417 +101 2 8.40154 10.6596 2.53141 -0.930044 -1.16348 -6.83089 +102 2 8.61337 9.15635 2.20556 -3.35942 21.7495 -11.7521 +103 1 10.5245 1.75336 15.553 -8.62776 -1.95945 -5.61675 +104 2 11.4377 1.70086 15.8172 12.2485 -3.82632 7.39579 +105 2 10.5516 1.84495 14.595 -9.16331 1.82149 -1.12185 +106 1 2.77042 12.9421 7.75317 -7.76237 -6.33315 7.0975 +107 2 3.33238 13.5624 7.27685 -2.67968 -0.352894 -3.41328 +108 2 2.03777 12.7029 7.16368 7.79305 2.46945 -1.53229 +109 1 3.64399 11.6862 5.32015 -16.8384 -12.8234 -6.75612 +110 2 3.34983 11.0669 6.0167 8.99611 10.2661 -11.4747 +111 2 2.85416 11.8487 4.76712 13.6242 -0.0526402 5.20338 +112 1 6.87773 14.4784 16.8504 -8.96924 2.55968 -2.39612 +113 2 7.58262 13.8601 16.6681 3.90388 -1.06505 3.99858 +114 2 6.56163 14.7581 15.9821 -2.66358 -1.99085 3.97159 +115 1 14.1744 14.5416 3.41044 10.3942 -0.651763 -8.74467 +116 2 13.655 15.3132 3.20132 -4.79611 11.1016 -3.67227 +117 2 13.7666 14.1672 4.18264 -6.53868 -10.5118 9.50782 +118 1 8.26761 18.1769 16.0723 60.4333 -9.62543 6.95109 +119 2 8.90915 17.473 16.3173 -32.2452 -3.35667 -3.16806 +120 2 8.92378 0.250762 16.016 -23.6515 10.2222 -7.97846 +121 1 4.73314 1.61844 4.90498 10.4838 29.1168 -20.5116 +122 2 3.92346 2.13642 5.08344 11.5633 -7.75976 -5.77828 +123 2 5.26159 2.15735 4.23518 -22.3286 -21.1319 29.8735 +124 1 15.1246 12.8394 16.4387 17.4381 -4.51065 31.9511 +125 2 14.6778 12.9897 17.2989 -1.10989 -1.43715 -21.8055 +126 2 14.5277 12.6911 15.7205 -25.4533 -1.78625 -11.0751 +127 1 15.7863 18.3852 16.7922 25.908 13.3822 31.678 +128 2 16.4574 18.6243 17.5189 -32.4234 -15.7026 -31.1655 +129 2 15.6278 17.4293 16.8067 2.01305 5.51074 5.25351 +130 1 1.13886 1.13555 16.5514 1.07915 19.6556 20.6288 +131 2 1.93696 1.57732 16.8903 -4.88731 -5.90564 -11.4186 +132 2 0.480719 1.50241 17.171 6.36092 -10.7053 -11.3623 +133 1 18.0845 4.58532 15.87 11.914 -13.2929 -3.66508 +134 2 18.5793 3.94883 15.3177 -8.66069 11.808 8.70591 +135 2 18.5822 4.70936 16.6848 -0.518448 -1.56194 -3.55701 +136 1 12.2302 16.9486 16.128 -37.9176 -11.5423 26.3029 +137 2 11.3914 16.5899 16.5469 36.4287 7.40626 -6.62059 +138 2 11.916 17.193 15.2634 5.93841 3.5336 -18.1806 +139 1 15.8788 2.54988 17.9721 5.087 5.67773 0.124923 +140 2 15.7549 3.4391 18.3687 -1.45045 -15.8437 -11.8457 +141 2 15.6801 2.58174 17.0093 2.38633 7.36977 18.7833 +142 1 6.70786 13.8001 10.254 -2.60372 -2.62943 9.53833 +143 2 6.60649 13.5148 11.1732 2.18143 10.2669 -0.00882184 +144 2 6.57676 12.9909 9.76432 1.5038 -4.69959 -12.8892 +145 1 10.141 18.2121 2.80409 9.87418 27.4677 -18.8777 +146 2 10.2555 0.291999 2.14056 -0.137226 -16.5556 14.9505 +147 2 9.2689 17.8819 2.61553 -12.127 -4.1331 -0.131977 +148 1 2.97228 17.7542 6.06181 -6.28377 0.301135 37.0401 +149 2 2.07671 17.601 5.72694 10.6784 2.25774 -14.0772 +150 2 3.63482 17.801 5.37776 -0.270923 -2.52512 -18.6151 +151 1 12.5659 17.001 7.96656 -23.415 -18.3905 24.197 +152 2 11.9071 16.2804 7.97312 11.7411 4.46809 -11.7089 +153 2 12.3405 17.4671 8.78984 12.2149 7.72109 -10.0441 +154 1 14.887 15.2779 8.2893 -14.8827 1.47652 2.73183 +155 2 14.0296 15.7117 8.25541 -5.1427 0.792443 13.0916 +156 2 15.1979 15.4906 7.42354 24.2513 -3.00083 -20.068 +157 1 17.5454 18.3111 0.374663 -13.7707 -4.14946 -2.00055 +158 2 18.2555 17.754 0.11924 20.0055 -25.3354 -15.9225 +159 2 18.0059 0.295965 0.896687 2.592 26.2966 16.2474 +160 1 0.909555 10.373 1.4127 -25.0541 -38.6286 23.1399 +161 2 0.0989843 9.87796 1.71715 28.402 10.794 -7.01331 +162 2 0.540787 11.0804 0.922273 -7.26144 30.0328 -22.846 +163 1 1.56438 12.1819 3.32547 9.10171 15.3717 9.49092 +164 2 1.376 11.5384 2.66679 -5.32309 -27.3061 -8.25977 +165 2 1.61002 12.9703 2.79202 3.36268 15.5511 3.76031 +166 1 0.549815 17.2556 4.8751 10.3167 15.4421 -19.2536 +167 2 -0.00199658 17.9163 5.26632 -10.5855 22.2192 -2.30371 +168 2 0.434878 16.519 5.43169 0.723696 -37.6018 20.4622 +169 1 1.10394 1.00198 9.3932 22.7427 9.86492 -7.57605 +170 2 1.42144 0.685439 10.2466 -8.09769 -6.36772 6.76546 +171 2 0.213433 0.697197 9.27667 -15.9263 -9.88137 4.21803 +172 1 16.7947 2.33275 13.2864 3.73194 4.84267 -27.3174 +173 2 17.0439 2.54012 12.3481 -6.98409 -4.39606 26.1758 +174 2 16.4729 1.42155 13.294 0.162444 -0.657512 2.21945 +175 1 2.4659 15.8297 12.1956 27.3811 -11.2673 13.1923 +176 2 2.9226 15.5311 13.0144 -9.82996 7.11615 -19.573 +177 2 2.93231 15.4201 11.4444 -5.86947 6.23921 4.54204 +178 1 16.4361 15.5441 5.94616 -3.08145 19.3328 -8.8947 +179 2 17.3593 15.4783 6.2724 -11.5576 7.7283 -8.52746 +180 2 16.3183 16.2893 5.29043 11.1937 -18.2696 22.1006 +181 1 5.84475 5.01999 11.7951 -3.08481 -3.45829 -4.75382 +182 2 5.52388 5.87345 12.0737 0.2772 11.9484 7.56792 +183 2 5.11411 4.43946 12.0133 1.47645 -8.9756 -0.689037 +184 1 15.224 4.86392 0.726277 -25.4938 -12.7349 25.4219 +185 2 14.7355 4.51715 1.53205 23.492 12.9767 -22.6649 +186 2 14.5328 5.02763 18.7193 1.17802 2.78752 1.94947 +187 1 16.3449 16.2967 2.11437 10.483 7.37611 -22.6614 +188 2 15.9997 16.7982 2.83675 -10.4405 6.50893 22.1211 +189 2 16.6677 16.9984 1.52582 -1.93062 -9.0043 0.169523 +190 1 0.302094 4.87802 3.79689 -13.2533 37.9479 3.00012 +191 2 0.313912 5.8808 3.95538 6.86913 -44.9842 -7.10747 +192 2 1.1462 4.49233 4.0346 3.71094 3.5442 4.02727 +193 1 2.9221 14.9895 15.0397 8.46471 -6.33736 14.5665 +194 2 3.00495 14.6058 15.9566 -9.31495 16.4585 -22.1508 +195 2 2.45729 15.8402 15.0938 1.85721 -3.29548 9.95349 +196 1 1.12 14.5717 9.56227 17.989 48.8934 -19.0037 +197 2 2.07414 14.5222 9.32346 -20.956 -13.4859 7.84449 +198 2 0.791626 13.7731 9.9282 4.87275 -29.8773 11.3577 +199 1 13.6624 16.6636 11.5457 -10.5327 9.77879 -22.0557 +200 2 13.3286 17.4311 11.0186 6.18992 -14.9435 17.5347 +201 2 13.3805 15.8992 11.021 -2.34987 0.215756 7.80532 +202 1 4.73359 1.47857 0.718618 -25.3973 -6.06392 2.87887 +203 2 4.17185 2.00661 0.129453 7.95287 0.81937 2.61464 +204 2 4.09095 0.858388 1.12753 14.212 5.94905 -1.43657 +205 1 1.42476 18.4735 11.9056 -5.99404 19.5083 -8.93412 +206 2 1.23513 0.382953 12.6723 -0.378912 0.915416 0.341246 +207 2 1.89505 17.7259 12.2433 7.21066 -16.1249 4.04173 +208 1 11.5448 10.106 4.11346 25.2596 15.8213 -25.5125 +209 2 11.5283 10.5663 3.22641 -2.70186 -14.3529 26.6987 +210 2 12.5027 10.081 4.37886 -27.2068 -0.404219 -8.52489 +211 1 8.37485 12.1748 3.75184 -11.9448 24.9759 46.3975 +212 2 9.17743 12.5878 4.11803 1.10724 -8.54244 -18.9118 +213 2 7.75197 12.4339 4.49102 7.61965 -18.0915 -33.0697 +214 1 14.3244 4.03247 3.293 11.3964 4.48411 20.4985 +215 2 14.943 4.18459 4.05162 -10.8147 -3.75721 -20.4981 +216 2 13.4909 4.45368 3.55282 4.29688 -1.92648 -2.70238 +217 1 5.58313 1.77339 7.50694 -37.3093 -46.6507 29.7736 +218 2 4.97145 1.12464 8.0478 36.2685 39.0776 -31.448 +219 2 5.37556 1.59155 6.57949 1.79923 3.69516 -0.386563 +220 1 17.9058 1.11523 4.88403 9.14173 18.8744 -7.73144 +221 2 18.4454 1.57607 4.20954 -6.0377 -15.1011 6.62684 +222 2 17.7347 1.81107 5.53023 -2.74058 -7.94095 2.09707 +223 1 6.8279 9.39776 4.48823 3.62694 -0.974221 -6.28613 +224 2 6.84568 9.51125 5.43283 -7.5389 4.30482 14.2207 +225 2 7.717 9.07508 4.31798 2.90721 -0.358573 -8.96695 +226 1 2.70207 14.9601 1.96467 9.48597 -9.94138 -22.1344 +227 2 3.35633 14.7518 2.62888 0.238693 -0.206349 10.2383 +228 2 3.16249 14.7444 1.12616 -13.7934 7.99556 12.9651 +229 1 17.2754 12.8959 13.1352 7.09139 -37.5845 3.69594 +230 2 16.3537 13.1102 13.3148 3.80173 19.6017 -1.81888 +231 2 17.838 13.6507 12.9698 -8.26303 20.1956 -1.14982 +232 1 15.0171 10.5799 1.38486 -27.8548 -28.8799 -20.6854 +233 2 15.5438 11.2121 1.82149 21.7425 28.5078 17.6295 +234 2 14.2994 11.069 0.967203 2.72678 -1.55793 4.42244 +235 1 5.71388 6.94387 4.52744 5.06868 -23.5408 12.0019 +236 2 5.87421 7.87915 4.41499 3.45829 8.88765 -0.888191 +237 2 6.40286 6.63416 5.14703 -8.303 0.627238 -7.76707 +238 1 8.10838 8.26645 10.1831 -2.58942 7.80898 11.2224 +239 2 8.62669 8.8788 9.66253 10.4484 9.83111 7.1505 +240 2 7.63286 7.80673 9.50478 -12.057 -13.4779 -6.03182 +241 1 13.5281 18.2914 5.80176 -22.4215 -1.8227 14.6872 +242 2 12.749 0.212336 5.63336 9.50875 -1.85743 -1.68773 +243 2 13.2346 17.7232 6.55015 8.07385 12.1374 -16.5266 +244 1 0.320637 2.55746 0.113707 -24.4854 52.0087 1.52013 +245 2 18.0083 2.70852 18.6241 7.28296 -16.9077 1.12853 +246 2 0.626424 3.4996 0.197011 8.79214 -31.4205 1.87945 +247 1 12.6453 10.9632 9.76861 -25.4211 42.834 -14.9231 +248 2 11.6492 10.8795 9.70071 37.3368 -7.50244 3.90461 +249 2 13.0228 10.1402 10.0352 -3.08107 -28.1376 6.91694 +250 1 0.78452 12.2807 11.0864 19.7349 -6.9692 -1.93691 +251 2 18.4749 12.3028 11.1225 -11.4863 3.49833 6.83674 +252 2 1.15231 12.659 11.9029 -10.6903 -3.95248 -3.68276 +253 1 5.04293 7.22507 13.482 3.09598 5.99749 -4.73795 +254 2 5.58886 7.93262 13.132 -0.232718 7.71962 -10.0141 +255 2 5.52798 7.00144 14.2755 -0.932575 -7.50807 9.86229 +256 1 1.28071 6.97469 11.8373 -31.3117 -37.3004 -11.5925 +257 2 0.492113 7.17802 11.3051 9.94401 -3.39318 6.90536 +258 2 1.685 7.80152 11.9673 18.2328 34.095 8.03536 +259 1 15.4541 9.47192 12.3133 5.85738 22.5951 5.06509 +260 2 15.5175 10.4638 12.3742 -4.62374 -31.0112 4.63394 +261 2 15.4968 9.06746 13.1992 -1.35817 12.6181 -10.5463 +262 1 16.6442 12.9519 5.45538 -21.4717 15.277 -31.3145 +263 2 16.3435 13.8787 5.41602 10.8128 -9.57177 19.5795 +264 2 16.428 12.7198 4.52965 10.5011 -15.0883 17.3079 +265 1 6.17539 10.0558 0.19339 -10.2788 -9.80575 -26.1597 +266 2 5.38875 10.4515 0.589333 6.07089 -1.52504 2.9393 +267 2 6.86188 10.0925 0.84877 11.0601 2.17112 10.8149 +268 1 12.366 6.05676 4.0416 -22.1854 -19.7968 12.9024 +269 2 12.3704 6.78834 3.44644 3.0333 22.1434 -14.5586 +270 2 11.4296 5.77117 4.03801 16.8285 0.174707 3.6691 +271 1 0.132536 12.8255 0.204274 -0.526736 3.63462 -3.55478 +272 2 -0.0162245 13.5547 0.824079 2.12041 -2.82991 -1.20796 +273 2 18.2367 13.045 18.0704 5.31007 -1.26571 4.82883 +274 1 3.83823 18.58 8.61434 -10.0824 -4.97514 -18.4016 +275 2 3.52069 18.2861 7.74382 9.30441 -4.40092 2.94392 +276 2 3.03757 0.306881 8.974 -6.88025 7.19874 10.2509 +277 1 7.39362 17.2775 4.45212 12.7302 8.58303 13.7229 +278 2 7.99666 17.968 4.81801 -14.6435 -15.1886 -20.2263 +279 2 7.36047 17.3088 3.48385 6.79225 7.50625 8.12072 +280 1 9.21958 17.0373 12.2266 15.7968 3.09867 9.11932 +281 2 9.35553 16.2013 11.7334 2.65662 13.4997 9.89778 +282 2 10.0046 17.242 12.8046 -16.9951 -13.4125 -19.4407 +283 1 13.3157 13.0082 7.94027 -17.3901 -31.9016 7.67948 +284 2 13.1929 12.2449 8.54147 -2.27359 6.97807 -8.06923 +285 2 14.1396 13.3907 8.1966 15.275 17.864 3.60781 +286 1 14.9833 2.94943 15.3513 6.95235 -3.03472 -25.2367 +287 2 14.3042 2.39498 14.9448 0.627233 -0.993788 8.39197 +288 2 15.6656 2.99789 14.6444 -10.442 2.78752 17.6131 +289 1 9.85751 15.5027 17.0048 6.47201 6.54967 -7.92386 +290 2 10.2825 14.6779 16.7304 0.0104739 2.25127 2.62159 +291 2 9.29444 15.3215 17.7618 -3.54568 -3.88732 3.90928 +292 1 11.2881 8.2507 16.5469 4.08161 11.4658 1.26949 +293 2 10.784 7.71518 15.9432 -10.4144 -1.78397 -10.2593 +294 2 11.7122 7.60386 17.1014 6.56418 -3.83522 10.5232 +295 1 3.78473 18.1936 16.723 -4.68023 16.7202 -12.0174 +296 2 4.25527 17.5912 17.2966 7.9068 -1.91441 12.6846 +297 2 3.78787 0.451609 17.087 5.31404 -15.3334 2.54941 +298 1 2.1979 4.10843 8.95106 26.9406 -12.5237 33.2314 +299 2 3.04044 3.62982 8.81286 -17.1971 13.1508 -10.8815 +300 2 2.16124 4.09638 9.93984 -10.9226 5.8942 -24.7105 +301 1 9.90906 10.3512 9.74092 -24.4032 35.3078 2.18412 +302 2 9.42476 11.1784 9.45919 17.314 -27.1904 0.11143 +303 2 9.91744 10.4013 10.7102 5.12409 -5.92526 -7.2544 +304 1 9.73754 0.812356 10.8589 -9.45704 -2.93658 -4.01088 +305 2 9.44076 18.5949 11.1517 4.40065 -9.39685 13.0528 +306 2 9.08713 0.996724 10.1835 0.761981 14.6946 -8.69624 +307 1 9.19301 15.2105 10.2107 -22.2036 -10.0383 -7.82623 +308 2 8.98025 16.0713 9.80369 1.46967 -14.8527 4.99479 +309 2 8.36662 14.6679 10.1029 23.0402 13.9843 6.10558 +310 1 0.991303 9.28993 10.3284 48.5242 0.758788 -7.3086 +311 2 1.23965 10.2015 10.4879 -14.9681 11.3684 1.41472 +312 2 1.89881 8.9146 10.1688 -36.1698 0.796544 3.16897 +313 1 16.8183 4.88742 8.19443 14.5542 -10.1877 33.2312 +314 2 16.1728 5.34475 8.77937 11.7085 -6.30946 -17.3069 +315 2 17.4003 4.3619 8.8005 -18.9368 13.5764 -18.1776 +316 1 14.6428 14.6932 0.395223 -8.43601 -1.47433 8.87339 +317 2 15.0319 15.2579 1.0921 -3.12605 -9.09789 -8.18687 +318 2 13.8519 14.2576 0.787234 16.4944 11.1317 -8.84191 +319 1 3.51972 11.0527 9.63241 -0.0258339 11.398 -8.76826 +320 2 3.50143 11.4368 10.5206 2.13389 -0.105265 -4.21661 +321 2 3.1724 11.7459 9.02999 3.72912 -11.0816 8.2725 +322 1 11.0404 10.8634 1.27208 6.70694 17.4362 -9.49329 +323 2 11.1727 11.6824 0.735781 1.31404 -20.4369 14.6488 +324 2 10.1116 10.6362 1.15363 0.362803 -1.95542 1.92755 +325 1 13.2201 7.06705 12.8916 -20.9652 2.88797 -6.38338 +326 2 14.1438 6.85164 12.9216 15.9393 -3.58362 1.12932 +327 2 12.7477 6.22232 12.897 3.28641 3.49729 -0.863357 +328 1 9.62872 1.89177 0.948251 6.96093 0.24991 16.0649 +329 2 8.76715 2.00519 0.577625 -19.1552 -2.18542 -3.65809 +330 2 10.1854 1.76875 0.19003 12.4655 1.79214 -8.44775 +331 1 10.594 13.5319 4.7375 16.0423 -1.41644 13.6035 +332 2 11.415 13.0379 4.93682 -11.8157 3.93147 -13.4525 +333 2 10.5255 14.1008 5.52348 -3.94863 -4.31219 -11.1546 +334 1 14.2685 1.70153 10.8945 -3.08057 3.85383 7.15216 +335 2 15.0552 1.23258 10.5836 3.50278 10.8149 -1.53255 +336 2 14.4104 2.66429 10.8947 7.37053 -8.35752 -2.77651 +337 1 14.6611 12.4198 11.7249 1.4364 -26.5965 -56.3444 +338 2 15.4897 12.4837 11.202 -5.7241 6.85295 22.6084 +339 2 14.0924 11.9909 11.0313 1.01548 12.4899 31.9742 +340 1 8.24953 5.08668 9.79072 -30.3058 0.287699 22.814 +341 2 7.41708 5.03925 10.3073 16.545 17.0491 -5.32162 +342 2 8.22462 4.2143 9.42755 11.9131 -18.3304 -16.4659 +343 1 1.59402 16.8187 18.3253 -6.20255 31.6963 -6.78121 +344 2 1.91227 17.2067 17.482 -4.95179 -10.2412 13.7563 +345 2 1.83336 15.9037 18.3179 8.32765 -17.6711 -3.36436 +346 1 1.43897 17.2464 15.3358 29.6054 -7.17934 -6.21787 +347 2 1.36087 18.1379 15.637 5.97318 20.4573 7.89508 +348 2 0.556137 16.9475 15.3273 -33.612 -15.1267 -3.09538 +349 1 3.72895 5.57357 6.20543 -8.92972 12.8219 1.61975 +350 2 3.23079 6.21113 6.76482 10.0758 -7.74032 -14.0976 +351 2 4.28418 6.06511 5.5772 -4.67021 4.78615 6.0759 +352 1 12.3529 9.4251 14.1822 19.6727 -43.1834 10.5387 +353 2 12.884 8.61082 13.8993 -22.621 36.8155 4.19437 +354 2 12.0516 9.14148 15.0731 3.60544 11.6456 -14.396 +355 1 4.03531 15.2728 6.90881 24.4865 3.71204 -3.62934 +356 2 3.44033 16 6.68284 5.60112 1.73001 -3.29651 +357 2 4.96253 15.5542 6.68078 -28.8575 -4.96404 7.1648 +358 1 0.605953 8.56457 14.8638 -0.120582 -0.391313 3.99343 +359 2 0.501042 9.52227 15.005 5.35221 -7.46858 -4.68281 +360 2 1.25554 8.44629 14.1506 -6.09669 6.93914 6.70414 +361 1 12.9734 8.36578 10.3368 20.5003 -18.2509 -7.79226 +362 2 13.7393 7.86937 9.99522 -8.8873 10.1321 -9.444 +363 2 12.9708 8.03443 11.231 -10.3099 3.90117 14.6287 +364 1 15.2894 7.6332 3.49269 12.7581 18.2329 -13.143 +365 2 14.5338 7.17315 3.08677 6.1918 -0.800492 21.6775 +366 2 15.5136 7.51531 4.43453 -15.4019 -14.7068 -6.3771 +367 1 17.3212 6.64473 0.0316567 -27.1824 12.6283 -1.8657 +368 2 16.771 5.99448 0.499966 9.26154 0.672542 -4.32476 +369 2 16.64 7.24337 18.2783 17.9792 -11.5061 8.92142 +370 1 8.80668 6.92454 7.83918 -24.3908 -17.2325 7.20576 +371 2 9.68081 7.28212 7.80962 25.7376 5.86496 2.86911 +372 2 8.71775 6.37228 8.64787 6.10597 9.33115 -12.275 +373 1 12.3202 0.615137 1.17425 13.6931 -3.72396 -2.19539 +374 2 13.075 0.992886 1.63957 -0.40119 2.44364 5.09949 +375 2 12.7571 18.5667 0.666384 -10.9298 0.853201 -1.96514 +376 1 5.6785 15.1027 14.5126 8.23045 15.6484 -5.86338 +377 2 4.72039 15.1784 14.5966 0.299323 4.01186 0.94539 +378 2 6.04535 15.9236 14.1081 -12.4379 -14.8055 10.7649 +379 1 3.83406 6.52943 1.68496 -5.12703 10.9404 0.999964 +380 2 3.44824 7.31709 1.2662 3.88585 -11.3877 -2.55221 +381 2 3.84338 6.82178 2.59771 5.33619 -6.06857 7.79227 +382 1 3.88904 11.6132 12.2401 8.95627 -8.79814 -2.40389 +383 2 4.75841 12.0277 12.3683 -7.0992 0.0294616 4.018 +384 2 3.233 12.1226 12.7151 -2.84239 9.6423 6.84851 +385 1 5.44987 3.87776 15.8711 9.04603 51.7105 12.2927 +386 2 5.99752 3.20763 15.4917 15.5436 -17.9801 -7.19396 +387 2 6.04703 4.69158 15.9698 -28.7283 -34.9666 -5.01916 +388 1 14.4605 10.3225 4.39641 11.4537 -30.5762 -31.9722 +389 2 14.8306 9.83502 5.14205 -5.39586 2.29688 2.9797 +390 2 14.6901 9.75629 3.58792 -12.4512 26.4694 34.1579 +391 1 7.94485 17.2962 9.23406 -29.3852 32.3044 -4.90329 +392 2 7.20157 17.582 9.8013 11.6936 -12.8295 -3.21694 +393 2 7.93254 17.9646 8.52624 8.85814 -10.3239 0.926379 +394 1 4.49873 14.4249 3.9575 27.1774 17.1098 41.9883 +395 2 4.83669 15.3326 4.20793 -17.2661 -25.1881 -14.2087 +396 2 4.80599 13.8528 4.71739 -13.53 13.4591 -29.2523 +397 1 14.3284 7.3854 15.7629 16.5671 6.07561 9.97379 +398 2 15.2454 7.23106 15.4511 -19.609 3.15959 8.32151 +399 2 14.4426 7.80786 16.6389 -4.4507 -8.27801 -15.1382 +400 1 2.87403 18.2247 1.90389 13.9577 30.3231 32.1513 +401 2 2.546 17.6397 1.25326 -17.0615 -24.6646 -23.5795 +402 2 2.12038 18.5502 2.43008 9.19244 -2.23706 -9.85686 +403 1 7.96361 1.60549 4.53489 27.0952 14.1367 0.307488 +404 2 7.49638 1.9472 3.77739 -15.4877 0.180801 -4.55719 +405 2 8.8215 2.06687 4.46869 -11.5471 -13.5362 7.94734 +406 1 2.67177 14.1298 17.7578 -32.0965 -17.6674 6.84649 +407 2 1.82063 13.6639 17.9969 26.9839 12.0838 -7.18622 +408 2 3.38659 13.5743 18.1098 -5.52669 6.70603 -3.66321 +409 1 0.723551 1.68725 13.8621 17.7332 3.27009 -2.43746 +410 2 0.829271 1.51069 14.7908 7.98206 -4.95309 12.0999 +411 2 18.44 1.84118 13.7764 -20.4783 4.25661 -8.09669 +412 1 4.55406 18.6 13.9636 17.2604 -7.63309 -9.35161 +413 2 5.43897 18.1924 13.8214 -18.4623 11.1021 3.79828 +414 2 4.32329 18.399 14.8757 -4.15164 0.0521115 2.41255 +415 1 7.10455 0.474046 18.3679 -11.2359 27.2348 29.1061 +416 2 7.12016 0.115813 17.4965 -1.63433 -6.1865 -23.0052 +417 2 6.24271 0.910062 18.5515 12.5771 -12.8936 -7.91243 +418 1 16.1005 18.44 14.1333 -36.4501 -27.5791 -6.57953 +419 2 15.3829 17.8174 13.8465 25.6281 20.8019 -1.7164 +420 2 15.9077 18.5395 15.0719 9.49834 8.44163 -0.14337 +421 1 10.1046 4.52059 16.2893 -46.9792 2.1543 -16.8809 +422 2 11.0012 4.49779 16.5541 31.7343 -4.51398 5.87687 +423 2 9.86248 3.65729 15.9089 12.0807 6.21086 8.83226 +424 1 15.8363 17.9271 4.41684 -16.1004 8.03032 22.5493 +425 2 16.5039 18.6299 4.52246 -8.60661 -6.24751 -1.3813 +426 2 15.0378 18.2098 4.9532 29.0614 -11.0784 -22.6438 +427 1 6.9284 17.3613 13.7353 43.359 11.4946 7.60179 +428 2 7.46858 17.7163 14.5015 -21.3841 -13.8198 -23.6549 +429 2 7.59514 17.216 13.0184 -16.6797 3.36376 18.1603 +430 1 13.2847 6.56451 6.73769 -14.228 -11.1924 -15.3605 +431 2 14.2169 6.67596 6.68467 27.6084 8.49537 10.422 +432 2 13.086 6.40899 5.80997 -14.9004 -1.60425 -0.509451 +433 1 7.67719 2.38409 9.18276 -12.7481 -9.95901 -21.449 +434 2 7.23781 2.34079 10.0234 -2.84678 0.492631 19.9336 +435 2 6.97018 2.11077 8.55354 21.5545 6.86467 6.74712 +436 1 15.1528 14.8764 13.6487 -19.1236 6.62595 6.09279 +437 2 14.9964 15.042 14.5941 6.3649 -1.885 -8.0702 +438 2 14.3208 15.1168 13.2045 14.5757 -4.46306 2.19701 +439 1 9.29857 8.33432 3.70772 10.6355 -8.13532 4.49802 +440 2 10.1502 8.81328 3.76286 -8.0776 -10.0517 2.73632 +441 2 9.46492 7.39019 3.89736 0.427871 14.9166 -2.52044 +442 1 17.6858 13.4785 16.4504 18.1421 12.8824 -2.9019 +443 2 16.7336 13.3749 16.3876 -0.564153 6.32044 -4.53985 +444 2 17.9415 14.3223 16.0098 -13.7235 -15.3212 6.57805 +445 1 5.04165 10.6569 2.59879 15.0811 -13.5005 18.1704 +446 2 5.79991 10.2916 3.10884 -13.8602 3.81488 -12.1379 +447 2 4.57944 11.1735 3.25148 -7.64374 9.33605 4.93504 +448 1 3.71156 8.35988 10.3223 2.69392 -10.4458 7.32 +449 2 3.86762 9.29314 10.1995 2.90356 12.3134 -9.75827 +450 2 3.79851 8.25131 11.2818 -4.19061 -2.88345 -8.87222 +451 1 16.1009 7.11278 6.31821 6.57165 -19.5926 -13.3215 +452 2 16.7556 7.67982 6.75754 -3.32154 -9.30994 -6.24555 +453 2 16.5222 6.22545 6.20359 -10.7974 20.4957 5.39095 +454 1 15.1877 7.01217 9.11633 -0.942582 31.3193 -31.4924 +455 2 16.0087 7.4094 9.45282 -9.93766 -6.26011 -0.320925 +456 2 15.0368 7.51069 8.25256 3.47491 -21.9129 34.3614 +457 1 6.44498 13.1525 12.9077 -4.11711 1.46333 8.37594 +458 2 7.24124 12.6683 13.1519 -1.65948 -2.61146 -1.33868 +459 2 6.29723 13.796 13.6274 -0.63037 -8.66373 -16.4588 +460 1 12.122 4.49686 13.0678 27.186 16.1548 19.2119 +461 2 12.2551 4.61131 14.0219 7.12074 5.87928 -4.56992 +462 2 11.3374 3.99971 13.0395 -36.5276 -21.5475 -13.6693 +463 1 11.3413 8.18743 7.85231 -9.00357 4.77407 0.37365 +464 2 12.0188 7.6639 7.39095 2.25052 4.68793 14.2505 +465 2 11.6381 8.44006 8.74837 5.13859 -10.097 -12.5363 +466 1 17.1781 10.7776 7.41775 8.98079 -10.5429 4.93206 +467 2 17.827 10.053 7.20793 -14.7505 26.0455 -2.01259 +468 2 17.1485 11.4724 6.73654 6.61625 -12.2683 -1.04931 +469 1 5.23072 18.1435 11.0535 -19.1878 -10.0323 -1.26774 +470 2 4.70405 18.0783 11.8789 8.35901 -0.713622 -15.9457 +471 2 4.65273 17.8196 10.3204 13.2116 10.9899 16.482 +472 1 7.5638 17.6255 1.82385 0.18941 -4.57957 5.58349 +473 2 7.78527 16.8134 1.38126 5.66428 -18.4097 -0.230917 +474 2 7.45334 18.2192 1.09148 -1.66074 15.0057 -4.75644 +475 1 1.8616 12.9257 13.6096 9.14642 8.79388 9.51824 +476 2 1.6025 12.3584 14.3568 1.58601 7.25854 -8.04733 +477 2 2.19519 13.7677 13.9951 -8.21693 -20.1216 -3.01678 +478 1 9.73071 6.79429 14.803 -9.96431 20.7294 -5.24946 +479 2 9.965 5.93538 15.1079 4.49059 -29.2435 15.7374 +480 2 10.0131 6.81015 13.8895 1.7202 7.35701 -8.16934 +481 1 15.2073 4.3815 10.7753 5.02149 -7.87008 -1.3136 +482 2 16.102 4.07091 10.8622 12.544 -14.2164 -8.54624 +483 2 15.2461 5.11302 11.375 -14.5847 15.9831 9.57625 +484 1 11.1932 6.12384 0.161263 5.03411 2.82645 3.69768 +485 2 11.3288 5.17786 0.364595 -11.2178 11.9329 -9.49937 +486 2 10.2678 6.33084 18.566 9.25768 -12.2342 6.14633 +487 1 0.186838 11.3278 15.1363 -29.5173 30.1692 -23.1318 +488 2 18.3705 11.8565 14.4078 15.8912 -24.6881 20.4884 +489 2 18.5399 11.8236 15.9183 6.48048 -3.45982 -2.85079 +490 1 7.07004 9.14522 7.26474 -13.1186 -12.9635 8.90657 +491 2 6.53932 8.3872 7.60207 7.2147 19.6305 -8.47997 +492 2 7.95552 8.78183 7.22801 5.51641 0.721385 -0.901037 +493 1 18.4462 15.4465 12.3531 0.397712 -4.42488 4.01328 +494 2 0.764911 15.5581 12.2944 -10.8471 -1.16552 -3.91149 +495 2 18.1036 15.6779 11.4829 2.90793 1.2817 1.1609 +496 1 16.5729 4.36464 5.24677 -25.0478 -7.96005 29.4563 +497 2 16.6771 3.95228 6.15287 5.89012 16.1194 -31.2199 +498 2 17.3789 4.38374 4.73556 17.0857 -2.87844 2.77648 +499 1 17.7776 3.07164 10.7152 20.2072 1.91324 7.6701 +500 2 0.0768882 3.1314 10.9751 -16.1773 7.43675 -1.86825 +501 2 17.7244 2.20926 10.3009 -7.90603 -5.17093 -4.6179 +502 1 12.3097 0.0632784 10.17 -5.23585 14.9609 -0.662134 +503 2 11.3669 0.329281 10.3192 28.4735 0.874848 -0.34084 +504 2 12.8997 0.858518 10.2668 -24.0851 -21.9241 -3.33166 +505 1 10.3626 9.82488 12.3121 10.8795 10.4681 17.7395 +506 2 11.1241 9.87716 12.9295 -11.9387 -4.40292 -9.54779 +507 2 10.179 8.8911 12.2253 1.1465 -9.5921 -0.185536 +508 1 0.479623 2.83009 7.02164 2.3472 21.5918 -9.19818 +509 2 0.779466 3.61946 7.51564 -3.03286 -18.4976 -0.625243 +510 2 0.704445 2.06385 7.54355 5.66126 -3.27927 9.79357 +511 1 0.467007 15.244 6.91284 -2.81724 -38.2268 -9.44322 +512 2 0.589986 15.6097 7.78713 1.11258 -6.7374 10.833 +513 2 0.615386 14.2454 7.00377 -3.57496 47.8567 -6.78063 +514 1 16.9531 7.01102 15.3314 25.0955 -6.26352 -3.35293 +515 2 17.7312 7.54015 15.1398 -4.24099 15.1997 -5.49373 +516 2 17.3882 6.19624 15.5982 -13.584 -8.29127 -0.013797 +517 1 9.00968 12.4205 8.1448 -47.4595 3.97518 -14.6445 +518 2 9.255 11.8265 7.44329 24.3825 -11.7648 -7.05727 +519 2 8.04408 12.5071 7.93332 27.0995 7.32888 21.0703 +520 1 1.26609 1.94093 3.05591 2.05426 9.79258 -12.831 +521 2 1.21698 2.59367 2.33971 -7.6512 -12.9321 3.35408 +522 2 1.90984 2.32941 3.65026 1.81811 -2.05605 5.16186 +523 1 4.13335 15.1162 9.63732 -3.37236 0.94273 -0.929026 +524 2 4.11982 15.1465 8.67375 -6.81504 5.04573 1.04836 +525 2 4.9784 14.712 9.81623 8.98269 -4.0071 9.77097 +526 1 7.18021 2.17978 14.5671 7.55504 9.68183 9.47496 +527 2 6.93575 1.71258 13.7681 -0.50379 0.233559 -6.02908 +528 2 7.66352 2.97784 14.2972 -3.4628 -8.48803 0.116771 +529 1 18.6085 14.7119 2.15295 17.2538 -25.5542 -3.98016 +530 2 0.854482 15.0949 2.23403 -8.04084 1.8593 -0.311551 +531 2 17.9464 15.3611 2.33256 -11.9957 20.7574 3.41759 +532 1 9.94838 2.78838 12.9451 -1.38176 -12.4025 -13.9087 +533 2 9.76343 2.19068 12.1969 8.49761 3.03822 8.73498 +534 2 9.19943 3.38599 12.9407 -2.82035 8.06337 4.45668 +535 1 2.81023 8.91387 13.015 -11.0947 -9.09099 -1.03322 +536 2 3.12702 9.79437 12.8576 7.30933 17.7942 -2.89213 +537 2 3.52626 8.44288 13.432 10.5553 -8.83156 6.15268 +538 1 3.22981 8.35572 3.63929 7.91603 12.3414 59.3292 +539 2 3.55022 9.08279 3.12704 6.39159 12.4302 -19.4578 +540 2 3.47038 8.64809 4.58003 -14.7797 -20.4427 -37.089 +541 1 5.63158 7.19787 8.5111 -16.5836 -10.0318 8.45115 +542 2 5.49703 6.26423 8.32413 12.2862 -3.4998 -5.25722 +543 2 4.92977 7.35667 9.15199 5.58983 12.4707 2.72685 +544 1 14.8806 1.27947 2.01044 -5.20911 -29.6221 -13.7523 +545 2 14.8531 1.98102 2.64457 3.54145 24.2946 3.1913 +546 2 15.2413 1.51873 1.14568 -0.321243 12.6895 5.96264 +547 1 8.23741 15.1928 0.849855 10.5438 9.56485 -11.8122 +548 2 9.03414 15.1092 1.40038 -9.07879 -4.36113 3.60062 +549 2 7.50349 14.6875 1.21874 4.98636 -2.78068 7.26539 +550 1 15.6325 1.34538 7.23629 -19.2726 -10.6819 -7.69516 +551 2 14.9548 0.715658 6.87861 16.0521 20.279 9.35294 +552 2 15.1584 2.15623 7.4957 0.78871 -9.00488 -4.70177 +553 1 4.90948 13.0908 18.526 11.7484 -4.19917 14.2638 +554 2 5.32661 13.1046 0.771936 -5.81675 2.26251 -17.1314 +555 2 5.47193 13.6353 17.9612 2.08739 -3.03703 1.40027 +556 1 15.3444 8.47528 18.1477 10.5782 11.2904 -17.9652 +557 2 15.7712 9.10441 17.5134 -10.1785 -13.1115 16.9911 +558 2 15.2549 8.94211 0.342082 0.277618 5.95495 -1.45242 +559 1 12.072 3.0348 18.3713 9.16845 -16.043 3.97866 +560 2 11.9997 2.53228 0.532204 -11.5106 10.3924 18.501 +561 2 12.5782 2.36842 17.9104 5.62845 7.32417 -26.0863 +562 1 13.2089 12.6783 5.18015 6.63876 -6.29032 2.85699 +563 2 13.7391 11.9795 4.78379 -2.73226 -0.00342211 -8.22979 +564 2 13.3831 12.5487 6.11225 -3.40081 8.86391 8.40941 +565 1 6.04915 7.04527 0.0350485 10.8742 -21.2203 -4.52865 +566 2 6.02805 7.99092 18.6226 -5.46576 23.9499 6.727 +567 2 5.33859 6.76219 0.618839 -5.51003 3.35157 1.33709 +568 1 17.7393 16.0214 15.0094 13.9302 -13.9422 41.059 +569 2 16.9573 16.5339 15.2303 -2.65419 1.12677 -17.6965 +570 2 17.9199 15.9264 14.0844 -11.8828 6.17072 -25.9912 +571 1 13.1897 1.00209 16.5482 9.0285 -11.9403 8.82412 +572 2 14.1531 0.926941 16.6936 -12.5978 2.36886 -2.70952 +573 2 12.8801 0.0805392 16.5939 -0.793518 8.62378 -3.88342 +574 1 11.1147 14.5676 7.20714 13.0879 22.2032 -16.1382 +575 2 10.392 14.3041 7.74555 -20.7251 -13.6554 17.189 +576 2 11.8256 13.9392 7.33494 4.5733 -4.90634 5.95678 +577 1 17.5119 8.63301 2.08454 0.0660302 9.5119 10.6671 +578 2 16.6736 8.51459 2.527 -7.33525 3.37542 8.64387 +579 2 17.5132 7.89769 1.49414 7.23803 -17.2019 -20.825 +580 1 12.3543 7.99739 2.01665 -2.5776 9.38468 -13.8973 +581 2 12.1955 8.87571 1.62365 2.26325 -8.37679 12.9533 +582 2 11.9634 7.39841 1.37453 -1.21895 -7.08079 -1.91625 +583 1 11.8862 14.6191 10.3431 -20.5633 -33.2885 -21.2052 +584 2 12.048 13.7971 9.8109 4.18347 28.6601 18.3667 +585 2 10.9021 14.6739 10.3387 21.4811 7.86907 3.51893 +586 1 6.88785 7.04202 15.6064 18.5625 21.2571 16.3476 +587 2 7.79496 7.28653 15.325 -16.282 -10.9681 -3.58347 +588 2 6.76913 7.58838 16.4136 -4.66142 -14.4555 -17.927 +589 1 8.00173 4.72633 13.4744 30.8534 11.0647 12.2619 +590 2 7.23536 4.76996 12.9314 -21.7993 1.23146 -17.3356 +591 2 8.43981 5.59806 13.3773 -8.25054 -18.6352 3.63378 +592 1 13.408 12.1818 14.2607 -3.38159 -13.7589 -5.77775 +593 2 13.0599 11.273 14.209 4.17969 5.9499 4.9999 +594 2 13.8015 12.3234 13.3884 0.552928 6.09909 4.73433 +595 1 14.8332 9.42219 7.30259 -3.18701 -8.441 -7.55641 +596 2 15.6639 9.86655 7.42287 15.173 5.4083 -0.0492361 +597 2 14.1987 10.0431 7.62107 -17.8235 6.30723 6.71627 +598 1 12.6528 17.0596 3.07812 -8.70602 18.4808 5.33985 +599 2 12.9496 17.4673 3.92869 -9.46791 -7.74089 -22.4319 +600 2 12.0101 17.6853 2.63014 23.5323 -19.7514 22.4129 +601 1 1.16198 7.14088 17.4585 -7.06812 8.47411 -13.2553 +602 2 0.305081 7.19087 17.9183 5.00325 -4.47293 -7.14563 +603 2 1.04973 7.54449 16.5661 0.440843 -6.25707 18.2149 +604 1 12.7703 5.1502 15.6519 20.537 -9.206 9.03076 +605 2 13.4569 4.49661 15.9358 -13.2491 19.9411 -11.3493 +606 2 13.2029 6.02791 15.5919 -0.675517 -15.6076 2.74775 +607 1 2.52973 3.39372 4.98628 -12.5021 24.9114 40.8727 +608 2 1.78336 3.12225 5.60975 27.8197 11.256 -19.0698 +609 2 2.94772 4.23746 5.36491 -19.3389 -38.1774 -13.5008 +610 1 8.3189 11.2987 13.4496 33.0028 -42.3062 59.2485 +611 2 8.52043 10.9592 14.374 -32.1909 27.8732 -26.3694 +612 2 9.06111 10.8351 13.0577 -1.72326 7.29715 -30.1092 +613 1 12.8789 1.33643 13.3362 0.40834 22.0058 -3.21803 +614 2 13.4118 1.44301 12.5159 -13.2456 3.30889 14.5055 +615 2 12.3632 2.16071 13.5095 17.0122 -18.2145 -15.4576 +616 1 6.34323 13.7037 2.15004 -8.90275 3.4942 1.01633 +617 2 5.67068 13.9831 2.80896 17.8093 -8.54249 -8.97759 +618 2 6.94017 13.0667 2.55763 -1.44693 0.407866 6.84109 +619 1 15.9207 6.60938 12.7941 -14.0219 -16.6873 -1.46208 +620 2 16.3665 7.21966 12.2297 10.4548 13.0291 -14.3606 +621 2 16.4032 6.61209 13.6164 4.57404 0.312906 11.3916 +622 1 16.837 0.713429 9.59537 -4.60186 -23.2491 -5.40047 +623 2 16.7766 18.3812 9.76009 1.861 23.059 -1.51736 +624 2 16.4539 0.846132 8.70764 2.52408 0.807103 8.64662 +625 1 6.14677 11.7538 8.37929 1.46343 -38.2042 -1.58984 +626 2 5.28119 11.5099 8.79312 19.6536 2.3972 -11.55 +627 2 6.62627 10.8955 8.13754 -23.51 30.7545 10.2414 +628 1 2.89887 8.61954 0.44521 -58.0253 1.44029 -30.8084 +629 2 2.28026 8.19904 18.4406 35.2092 -5.33136 7.34884 +630 2 2.23436 9.22701 0.790296 19.604 11.6332 17.9417 +631 1 10.1646 10.4607 6.5042 -2.67562 1.82661 -6.4385 +632 2 10.6119 9.73033 6.95167 0.990091 1.19991 -1.59039 +633 2 10.4858 10.4732 5.58284 -1.09389 -1.85789 13.424 +634 1 6.73063 15.6946 6.55447 -0.851851 -4.83477 5.20485 +635 2 7.09829 16.1491 7.32752 1.36873 0.436433 -10.1699 +636 2 7.02842 16.1335 5.74515 1.47904 6.69628 7.42626 +637 1 6.44804 13.1708 5.58287 -3.43311 -13.1021 10.8705 +638 2 6.66139 13.9646 6.07673 2.2473 5.97996 0.728386 +639 2 6.06157 12.5687 6.2363 0.868112 2.44944 -5.20285 +640 1 16.8203 12.5595 9.83963 -1.29973 -13.3798 -26.0882 +641 2 16.9797 11.9255 9.1094 -0.187484 2.38257 16.1818 +642 2 16.6351 13.3676 9.36293 0.809528 9.54538 5.72824 +643 1 6.04152 2.95052 2.84999 -1.13024 -25.4835 15.2707 +644 2 6.4006 3.79327 2.62573 5.01416 22.8678 -12.9444 +645 2 5.58314 2.5656 2.09763 0.434854 2.67004 -8.58918 +646 1 10.9107 3.32852 3.29939 -12.4238 -2.51051 -2.149 +647 2 10.2568 3.99067 3.55961 5.98057 0.0707186 3.553 +648 2 10.4887 2.88551 2.55708 3.841 -3.98893 -4.96007 +ITEM: TIMESTEP +20 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.69334 7.07477 17.9589 0.0661907 -8.15672 -5.93801 +2 2 7.76544 6.892 18.1438 2.06168 0.344835 4.67083 +3 2 8.87494 6.58302 17.1494 0.0923072 2.18051 2.08263 +4 1 18.5724 8.27759 6.8487 9.68108 -9.0135 5.9796 +5 2 0.0748736 7.96696 5.95521 0.0469709 2.78304 -15.7461 +6 2 0.399795 7.62446 7.38749 -2.21574 6.41883 6.02377 +7 1 8.4 18.5641 6.8134 3.87483 8.82198 -0.0595031 +8 2 9.32611 0.166963 6.70047 -3.24105 -1.28376 -0.166563 +9 2 7.89494 0.641414 6.41149 2.5055 -2.76566 0.153015 +10 1 6.59225 1.83896 11.6912 -0.275689 0.302437 5.80014 +11 2 5.92509 2.27303 12.2308 -4.07131 5.9643 -4.10931 +12 2 6.1821 1.00166 11.4658 -1.55571 -7.95905 -4.17259 +13 1 7.1255 5.73378 2.34451 -23.1841 27.0209 10.5427 +14 2 6.64356 6.29382 2.99422 10.5833 -21.9235 -2.45439 +15 2 6.93596 6.23963 1.54379 8.61204 -12.4491 -6.79559 +16 1 16.2118 10.162 16.1238 9.73263 11.3036 -6.58381 +17 2 17.0956 10.2901 15.7587 -2.05967 -6.96031 3.12171 +18 2 15.9212 11.066 16.279 -7.86411 -1.51367 3.55804 +19 1 10.6155 15.0016 2.3147 2.6864 2.11515 1.56294 +20 2 10.6002 14.5314 3.15674 -2.41534 -3.03603 0.679536 +21 2 11.0785 15.8209 2.51731 -0.0195897 0.981381 0.0978469 +22 1 17.1585 8.25197 10.4305 1.44624 0.93325 5.78222 +23 2 16.6499 8.94547 10.8694 -0.557047 -3.86734 3.9084 +24 2 18.0092 8.65295 10.2197 -0.225121 0.250414 -1.13708 +25 1 14.8741 15.8852 16.3481 -7.08493 -6.82471 0.413246 +26 2 13.9679 16.1979 16.3007 -7.09092 5.8218 -2.34027 +27 2 14.8494 15.2418 17.0641 6.82868 3.48864 5.90805 +28 1 12.1588 13.3817 0.433178 -6.27467 12.7595 -4.80914 +29 2 12.0352 13.6324 18.1551 4.79076 -7.76922 -3.88045 +30 2 11.6846 14.0735 0.910169 -3.08866 -6.36125 10.7585 +31 1 9.27449 5.40778 4.04397 -13.9365 -16.0184 3.55858 +32 2 8.80012 5.02015 4.81047 7.30704 13.9384 -9.37026 +33 2 8.62496 5.33174 3.3181 9.32114 8.483 4.67507 +34 1 1.82732 4.26294 11.6464 -4.04254 -2.69427 0.93532 +35 2 1.77693 5.20244 11.8864 -0.000737327 -7.07977 -0.141665 +36 2 2.24287 3.78422 12.3753 -0.858945 2.71416 -2.4423 +37 1 1.98268 6.82933 8.36887 -4.76513 2.22844 -15.7156 +38 2 2.36253 7.23451 9.15103 4.34961 -4.46197 5.21996 +39 2 2.01952 5.87123 8.47722 1.07428 0.125821 9.68028 +40 1 5.39566 4.39684 7.93565 8.0799 8.40992 8.79829 +41 2 5.46014 3.43633 8.01893 -3.87159 0.552259 -10.4859 +42 2 4.76986 4.63893 7.2446 -2.8004 -4.28351 -0.196723 +43 1 3.26324 2.92599 17.538 -6.48526 11.4036 5.90093 +44 2 3.9521 3.41084 17.0519 -4.33162 -2.5567 2.49087 +45 2 2.74469 3.58038 18.0606 14.1441 -6.64194 -12.4081 +46 1 7.47828 5.27232 6.10849 -6.04695 1.38866 -9.34596 +47 2 7.88111 5.94624 6.68322 -4.96979 -11.9122 3.47667 +48 2 6.82246 4.73008 6.58045 9.57964 11.031 7.72945 +49 1 9.77144 7.02208 11.9904 4.73189 -1.1383 -1.06285 +50 2 10.3467 6.38126 11.5734 3.30689 -2.46386 0.831607 +51 2 9.14216 7.24941 11.3005 -7.52384 3.80108 0.31383 +52 1 14.0798 3.55416 8.05513 -3.28328 4.35009 -1.93857 +53 2 13.7004 4.26501 7.52877 0.673114 -0.544944 -0.0617854 +54 2 14.5392 3.99696 8.77439 -0.252332 -0.945414 2.55344 +55 1 4.73763 17.2389 4.01031 -0.321378 8.61877 -17.0141 +56 2 5.59566 17.6635 4.11691 -0.835388 -5.76098 7.55997 +57 2 4.38449 17.6475 3.19969 -7.45685 -7.93836 11.3283 +58 1 16.5107 16.6056 10.0759 6.54448 8.81329 9.76337 +59 2 15.9397 16.7408 10.8388 -5.01232 -5.78767 -1.53078 +60 2 15.9723 16.2069 9.3894 -4.78788 -4.31379 0.495659 +61 1 1.96746 4.90416 0.450775 -1.81832 7.5424 0.20662 +62 2 2.57813 5.33173 1.07474 -1.76589 -7.7088 -3.71938 +63 2 1.58349 5.65244 18.6136 5.80255 -6.17515 -0.843526 +64 1 11.7761 13.343 16.2841 -6.04701 8.80367 11.8739 +65 2 11.2992 12.5177 16.4849 4.5736 1.77316 -11.3497 +66 2 12.2862 13.2596 15.4658 -7.12668 -12.5479 1.29578 +67 1 10.1128 11.0591 16.9331 1.69597 -16.074 1.546 +68 2 10.529 10.1874 17.0807 -3.30995 11.3925 -3.21813 +69 2 9.18388 10.849 16.7697 3.68635 3.27029 -1.84825 +70 1 11.7127 17.5197 13.4648 11.3019 2.11475 -5.22831 +71 2 12.331 17.0869 12.8651 -0.203424 -4.77186 2.96515 +72 2 11.9976 18.4453 13.422 -5.71015 -0.897636 4.76739 +73 1 6.35333 9.30557 12.2266 11.9787 8.60001 -4.91149 +74 2 6.91868 9.08658 11.4768 -7.06745 -10.6307 -2.02859 +75 2 6.87303 9.9972 12.642 -2.68502 3.03115 9.09234 +76 1 16.2229 12.7446 2.69624 -0.291567 -17.1772 2.14859 +77 2 17.0444 13.127 2.38556 1.82795 9.93981 0.639945 +78 2 15.5737 13.4355 2.84522 -0.398116 10.9003 -3.52894 +79 1 0.630414 12.571 5.87324 -2.78001 5.23525 -2.09291 +80 2 1.00794 12.4159 4.99822 -5.49855 2.79722 0.151968 +81 2 18.3568 12.8603 5.70082 10.405 -7.04854 2.54099 +82 1 5.20787 16.4001 18.4776 -12.5497 0.602195 -7.10426 +83 2 5.86464 15.8156 18.076 4.18722 4.70251 6.39081 +84 2 5.5918 16.9091 0.552483 9.38889 -4.76533 -0.723228 +85 1 0.52849 7.63403 4.08589 29.1287 17.8407 -12.6947 +86 2 18.5836 7.90722 3.36083 3.6478 2.13346 8.06342 +87 2 1.42012 8.03877 3.86645 -30.4536 -16.431 6.17599 +88 1 3.1381 8.91119 6.51072 -13.5755 -1.26875 13.9192 +89 2 3.59199 8.61596 7.312 -0.196935 0.713487 -8.34602 +90 2 2.19086 8.84537 6.73861 12.9731 1.00292 -6.41375 +91 1 7.31254 10.3111 16.1924 3.71601 3.69021 9.41051 +92 2 6.5835 10.5117 15.6001 -2.45726 -1.05124 6.16708 +93 2 6.97924 10.3433 17.1122 -4.5268 -1.10556 -13.1914 +94 1 11.1003 1.05051 4.99797 5.80988 -5.62906 14.1745 +95 2 11.3837 1.86623 4.56736 -9.38615 -1.44268 -8.87945 +96 2 10.7526 0.427875 4.34338 1.37635 7.2616 -4.61902 +97 1 4.41216 2.72626 13.196 4.39031 -15.812 27.2385 +98 2 4.68873 3.14242 14.0209 1.29771 13.5884 -6.24163 +99 2 4.35373 1.80262 13.5146 -5.93981 4.62314 -19.463 +100 1 8.39633 10.0477 1.8021 8.65231 5.58991 3.9521 +101 2 8.43584 10.7505 2.47552 -3.18527 -5.8592 -1.95349 +102 2 8.78245 9.25294 2.20632 -6.17245 6.11296 -0.869653 +103 1 10.5167 1.74791 15.5607 -12.987 -0.969766 6.95693 +104 2 11.4294 1.4693 15.6846 2.64548 4.13814 -6.20872 +105 2 10.3497 1.97094 14.6365 5.88046 -1.13362 -2.56443 +106 1 2.75172 12.9341 7.77038 -1.98364 -2.25212 -7.11701 +107 2 3.34024 13.5411 7.30753 1.72417 1.81116 5.40918 +108 2 2.20386 12.578 7.06153 -5.53374 1.90184 4.06344 +109 1 3.65904 11.6762 5.27167 1.4745 3.00351 -5.43274 +110 2 3.4246 11.0613 5.97769 -1.9036 -0.651658 -6.95213 +111 2 2.87422 11.8691 4.73548 4.37313 -4.77202 2.40024 +112 1 6.8497 14.4837 16.8623 -7.20011 -2.9268 7.54224 +113 2 7.64382 13.9472 16.8068 -1.68272 1.48794 -3.62778 +114 2 6.45279 14.5388 15.9848 5.36951 2.03983 -1.60361 +115 1 14.1732 14.5515 3.40534 8.00808 -4.71428 -5.83886 +116 2 13.686 15.3662 3.26714 -6.11485 0.946493 -0.0166146 +117 2 13.6673 13.9759 3.98664 -1.2314 3.40033 5.39954 +118 1 8.29912 18.1674 16.0589 -20.5282 -4.34905 -0.197762 +119 2 8.7408 17.3576 16.3653 13.9085 14.9544 -3.06277 +120 2 8.83266 0.312858 15.8727 12.6636 -13.3116 3.05514 +121 1 4.73053 1.62244 4.91728 3.73461 17.8941 -9.82498 +122 2 3.87083 2.07692 4.90413 8.70323 -5.84393 3.64668 +123 2 5.31846 2.19299 4.38363 -11.3635 -9.88313 3.69576 +124 1 15.0998 12.7921 16.4359 -16.5392 5.6559 5.83964 +125 2 14.613 13.1569 17.1797 9.93151 -3.40376 10.0434 +126 2 14.4182 12.7815 15.762 4.3611 -9.31248 -14.0367 +127 1 15.7898 18.3971 16.8042 5.79346 -1.22695 27.8179 +128 2 16.3329 18.5498 17.6117 -9.65553 4.21222 -20.1346 +129 2 15.4648 17.4968 16.9407 3.00983 3.14177 -9.23088 +130 1 1.14588 1.15091 16.5513 6.84042 -4.63386 -6.55399 +131 2 1.94328 1.67743 16.706 -5.62204 0.173811 5.06431 +132 2 0.528577 1.37004 17.2554 5.0728 5.5861 0.922174 +133 1 18.0913 4.5707 15.884 4.25376 -5.47852 -1.15194 +134 2 18.5654 4.01411 15.2573 -2.45188 0.25544 1.09753 +135 2 18.6545 4.64521 16.6589 -1.38654 0.113736 -2.45626 +136 1 12.2253 16.9711 16.1412 0.914186 -11.4555 3.91466 +137 2 11.5632 16.3741 16.5429 5.70701 14.4982 -7.43821 +138 2 12.0767 16.9746 15.1851 -6.52552 1.11271 2.73005 +139 1 15.9091 2.53324 17.9911 -0.813861 17.5084 -1.21546 +140 2 15.6764 3.36649 18.4268 1.17892 -6.2644 3.50604 +141 2 15.6868 2.72575 17.0644 4.5424 -10.5093 4.50867 +142 1 6.70264 13.8034 10.241 3.67042 13.5267 -3.47207 +143 2 6.65382 13.63 11.1889 -2.71481 -10.4168 -1.32753 +144 2 6.64075 12.981 9.74212 -1.13183 -3.39045 4.84834 +145 1 10.1303 18.2368 2.79334 3.88934 4.25391 -9.05815 +146 2 10.3528 0.228802 2.09034 -3.74927 -2.61302 6.3793 +147 2 9.24556 17.9143 2.58077 2.23777 4.46644 1.38681 +148 1 2.97822 17.7592 6.09436 6.84514 -11.0569 -16.6755 +149 2 2.2147 17.6257 5.53291 -18.2595 3.26089 9.16469 +150 2 3.66284 17.6557 5.427 11.9633 8.77303 4.67614 +151 1 12.5626 16.9639 7.98676 12.5848 -1.11028 -8.52053 +152 2 11.8839 16.2724 7.94525 -2.9484 9.81966 4.92503 +153 2 12.3706 17.6612 8.63222 -7.85492 -11.7975 4.91014 +154 1 14.885 15.2749 8.26678 1.09184 -13.1129 19.8008 +155 2 14.1202 15.8628 8.27106 1.10724 6.83397 -10.769 +156 2 15.4286 15.3633 7.48102 -5.52588 8.50153 -14.3957 +157 1 17.5862 18.2834 0.376986 -24.9344 -1.23553 -1.17468 +158 2 18.3469 17.8479 0.005767 18.8411 -2.89863 0.907383 +159 2 17.8259 0.448151 0.831731 10.0339 0.947456 -0.506579 +160 1 0.885899 10.3809 1.40397 7.22911 -11.5028 6.53987 +161 2 0.114071 9.81378 1.55479 0.851643 9.57639 -0.353744 +162 2 0.635753 11.1007 0.824785 -9.84019 7.34982 -5.0696 +163 1 1.59112 12.2023 3.3355 8.42913 -7.93475 21.5428 +164 2 1.38243 11.4488 2.766 -0.926106 10.11 -6.99043 +165 2 1.6499 13.0233 2.84482 -2.64968 -0.879455 -11.853 +166 1 0.551086 17.2511 4.8776 21.276 -3.63263 -24.3978 +167 2 -0.0762795 17.9651 4.97462 -6.3407 4.63135 13.3725 +168 2 0.558623 16.612 5.58807 -10.7338 -2.48853 14.1039 +169 1 1.11389 0.976548 9.40441 -9.70348 2.26791 0.52143 +170 2 1.20067 0.739298 10.3296 11.5619 -5.66825 6.05541 +171 2 0.194683 0.747268 9.24308 -0.993818 -3.51563 -8.196 +172 1 16.7801 2.33697 13.2827 1.26658 -2.58515 -3.42214 +173 2 16.9917 2.52603 12.3542 -2.2694 -1.44301 7.47438 +174 2 16.5315 1.40163 13.3451 -1.6586 3.84983 -3.29893 +175 1 2.50653 15.8317 12.198 6.9942 0.0378495 -5.39106 +176 2 3.03319 15.4932 12.933 -2.33393 0.151651 -5.20129 +177 2 2.92041 15.5438 11.3652 -1.63849 1.19534 6.62391 +178 1 16.4211 15.5676 5.95733 20.9565 28.2944 1.83954 +179 2 17.3426 15.5843 6.27645 -8.81355 -7.9692 1.26231 +180 2 16.3612 16.4166 5.46885 -9.28613 -17.0928 2.60564 +181 1 5.82453 5.03389 11.7824 5.33446 0.320875 1.57619 +182 2 5.57998 5.74431 12.3877 -7.39983 3.16893 -2.12011 +183 2 5.27405 4.27426 12.0034 -1.54313 1.61628 -0.196815 +184 1 15.2115 4.85871 0.718957 -12.3292 -1.21553 20.1953 +185 2 14.9951 4.64926 1.65891 1.99725 2.35951 -19.8125 +186 2 14.3839 5.18637 18.9796 8.05664 -2.8997 2.32554 +187 1 16.3489 16.3233 2.11444 -1.37403 -13.232 -8.15517 +188 2 15.9103 16.7203 2.87049 4.10511 7.42013 3.0617 +189 2 16.5474 17.0218 1.48672 0.743353 6.63736 2.3016 +190 1 0.282027 4.87119 3.80055 19.2835 17.3487 3.53091 +191 2 0.489613 5.83173 3.76503 -11.8967 -17.4303 3.14809 +192 2 1.11089 4.48306 4.11838 -9.18259 -2.61174 -2.176 +193 1 2.9303 15.0125 15.0392 0.0573492 -0.181072 31.7668 +194 2 2.82615 14.584 15.9186 6.41531 2.15453 -14.4377 +195 2 2.5906 15.8967 15.228 -6.81336 0.182398 -11.4579 +196 1 1.12223 14.6049 9.5632 13.1187 -18.7351 -0.898815 +197 2 1.97867 14.3698 9.19328 2.71847 14.7063 -6.21023 +198 2 0.940175 13.7592 9.98602 -14.9991 7.00648 6.43026 +199 1 13.665 16.6454 11.5316 -21.8339 3.0331 3.55613 +200 2 13.1746 17.4327 11.223 10.4467 -7.06131 -5.36321 +201 2 13.1002 15.9021 11.2581 8.49503 1.30575 -4.9094 +202 1 4.71709 1.47693 0.719081 -0.792104 -2.26487 7.67979 +203 2 4.13723 2.08795 0.242023 0.0358417 -6.61504 -0.0652634 +204 2 4.16248 0.903426 1.27536 -1.89276 3.42768 -9.42283 +205 1 1.43372 18.4947 11.8904 0.435024 0.903574 -5.06079 +206 2 1.25876 0.369488 12.6813 0.171373 0.403899 4.07674 +207 2 1.76959 17.6363 12.1756 0.0129122 3.12302 0.145238 +208 1 11.5344 10.1145 4.09755 11.0508 4.0163 -22.2825 +209 2 11.4066 10.5292 3.21014 2.38528 -6.34716 18.1192 +210 2 12.5036 10.0411 4.22804 -15.2135 3.993 -1.98571 +211 1 8.36281 12.1777 3.74701 -13.1943 -6.81146 -12.1909 +212 2 9.18722 12.6378 3.9579 -8.09176 1.3179 12.2751 +213 2 7.70079 12.2682 4.46238 18.0882 5.10492 -3.45512 +214 1 14.3344 4.02288 3.28855 15.2498 3.93213 6.6836 +215 2 15.0617 4.23514 3.91062 -12.0049 -4.72392 -3.76747 +216 2 13.5379 4.47251 3.60621 4.75183 0.0120405 -3.02562 +217 1 5.58434 1.74596 7.50985 -22.3692 -26.8297 9.12948 +218 2 4.91823 1.11394 7.92632 27.2868 23.8434 -15.8784 +219 2 5.43743 1.67946 6.54893 -3.28939 1.24453 9.56906 +220 1 17.9012 1.11073 4.88195 -3.31078 -7.47428 -4.80941 +221 2 18.5525 1.45486 4.25184 -3.70144 3.91348 6.86656 +222 2 17.7599 1.74881 5.59037 4.24211 2.13046 -3.7457 +223 1 6.8304 9.4053 4.48372 -13.6803 0.789023 -7.06041 +224 2 6.74666 9.48009 5.43928 9.48337 1.88908 4.46236 +225 2 7.74899 9.21301 4.27057 2.55497 -2.6247 5.048 +226 1 2.68932 14.9418 1.9668 -6.12139 1.43036 2.89635 +227 2 3.30587 14.7185 2.6759 1.77318 0.618157 -6.66396 +228 2 3.15681 14.9246 1.12432 2.70839 -4.47578 5.21755 +229 1 17.2859 12.889 13.1454 -5.46423 18.1991 -4.92566 +230 2 16.4361 13.3067 13.278 -15.9577 -14.9195 9.16742 +231 2 17.7285 13.6846 12.8505 24.3586 -1.49654 -2.29875 +232 1 15.0069 10.5712 1.38624 -2.11062 -3.1818 -0.491761 +233 2 15.5786 11.255 1.74854 2.03128 0.359313 2.4477 +234 2 14.2323 11.0405 1.08579 -5.34855 2.20107 -0.889893 +235 1 5.70672 6.90314 4.53443 4.24519 -5.28557 8.89432 +236 2 5.96576 7.83558 4.52332 0.860976 -3.32444 -1.54743 +237 2 6.34045 6.45199 5.11743 -0.773999 0.740319 -5.54545 +238 1 8.07933 8.28074 10.2171 -3.64639 -3.67369 23.1077 +239 2 8.76707 8.87858 9.90894 -2.7343 3.77639 -10.7375 +240 2 7.6749 7.81667 9.48055 2.86655 5.40525 -7.79011 +241 1 13.5084 18.3075 5.79227 -0.609935 12.5659 -0.945985 +242 2 12.8781 0.387145 5.63591 -2.7451 -9.905 0.332396 +243 2 13.1846 17.8335 6.57076 -1.7745 -1.29433 -5.46225 +244 1 0.277736 2.58212 0.118598 0.621477 -2.00702 8.56184 +245 2 17.957 2.7127 18.6839 10.2871 11.0559 -0.501636 +246 2 0.794319 3.38844 0.33639 -19.4232 -4.52538 -3.88061 +247 1 12.6801 10.9983 9.7602 -12.9965 -11.6862 -0.561246 +248 2 11.7228 10.8953 9.6485 6.19444 12.5166 -3.56604 +249 2 12.897 10.0826 9.9647 14.0656 0.707903 4.64438 +250 1 0.781933 12.2574 11.0872 -6.04901 -2.18816 6.07288 +251 2 18.4712 12.3682 11.1342 -4.62852 -2.97634 -7.25325 +252 2 1.06266 12.4852 11.9795 7.76729 1.60409 -2.26455 +253 1 5.05561 7.24886 13.466 -11.4852 -6.03635 -4.86876 +254 2 5.50236 8.03712 13.1394 10.7241 -0.576345 -1.34855 +255 2 5.49314 6.97472 14.2774 5.89817 7.37955 3.96262 +256 1 1.26581 6.94402 11.8396 4.62667 -0.613543 7.50244 +257 2 0.504801 7.20295 11.3208 -2.84364 2.86798 -1.49635 +258 2 1.66495 7.76854 12.1529 -2.34869 -3.61795 -5.23307 +259 1 15.4733 9.48228 12.3076 -4.70583 25.6475 16.0975 +260 2 15.3149 10.4406 12.4106 2.52372 -12.0579 -11.0564 +261 2 15.3983 9.16189 13.2139 2.67764 -6.7615 -6.72177 +262 1 16.6336 12.9201 5.4628 6.66579 -20.8603 16.0577 +263 2 16.5173 13.872 5.54201 -7.55482 0.841067 -13.5204 +264 2 16.4587 12.5944 4.56908 -1.3904 13.4091 -1.6671 +265 1 6.18458 10.0203 0.145227 10.7922 -3.52818 2.39688 +266 2 5.51531 10.431 0.700604 -4.05423 0.759005 -2.7608 +267 2 6.99302 10.1148 0.667984 -1.67417 -4.19008 -1.28624 +268 1 12.3589 6.06668 4.038 0.452115 -1.15559 12.336 +269 2 12.2616 6.902 3.56852 -2.7325 -0.676505 -9.18667 +270 2 11.4806 5.67315 4.10483 0.607886 2.8799 -4.57435 +271 1 0.151536 12.8218 0.203335 4.13456 -2.94622 -2.33064 +272 2 -0.0129983 13.5003 0.871422 4.06521 1.52419 -2.90371 +273 2 18.34 13.1254 18.0507 -1.07008 -0.669132 2.22617 +274 1 3.8124 18.585 8.59267 3.71655 -0.510361 5.11861 +275 2 3.56708 18.0759 7.80793 -6.58546 5.02297 1.51156 +276 2 3.01311 0.371537 8.92178 -4.29721 -3.94788 -5.16471 +277 1 7.41673 17.2735 4.46563 5.27699 16.8729 -12.8498 +278 2 7.96434 18.0381 4.66458 -2.5447 -1.66977 13.1327 +279 2 7.34622 17.3735 3.5102 -3.86431 -11.0257 -0.167405 +280 1 9.22722 17.0589 12.2393 19.2623 -14.5641 0.108859 +281 2 9.27149 16.2912 11.647 -4.87121 6.1965 2.03703 +282 2 10.0709 17.0037 12.729 -13.5572 10.6592 -2.64279 +283 1 13.3059 12.9585 7.95053 -5.93488 5.61094 -2.56551 +284 2 13.3162 12.2379 8.59837 1.79032 5.44422 0.740585 +285 2 13.8923 13.6822 8.21069 6.53108 -7.176 5.15054 +286 1 14.9676 2.9565 15.3436 -0.386658 0.574387 3.68052 +287 2 14.4202 2.18777 15.1252 1.77471 7.19316 -4.43588 +288 2 15.6633 3.03092 14.6718 -7.27619 -4.52831 0.823712 +289 1 9.86266 15.5244 17.0043 3.51131 -4.56125 -2.22878 +290 2 10.4016 14.759 16.7592 -3.4195 -0.793849 -1.98877 +291 2 9.23782 15.2217 17.674 1.65588 4.18023 5.21634 +292 1 11.2982 8.26605 16.5436 5.00814 15.3472 3.18516 +293 2 10.6561 7.79454 16.0057 0.999826 -4.04983 -0.0472571 +294 2 11.6606 7.65108 17.1873 -4.09078 -4.29715 -0.00155616 +295 1 3.81225 18.1964 16.7292 10.4788 2.16731 8.30533 +296 2 4.28955 17.5863 17.3008 -0.586781 -10.0924 -3.62086 +297 2 3.8829 0.368785 17.226 -6.17555 6.78007 -4.03101 +298 1 2.19803 4.12169 8.95254 -8.42555 5.0907 -8.8117 +299 2 3.07539 3.82533 8.67919 -2.6088 -0.1453 11.8715 +300 2 2.06404 4.00225 9.90658 13.5851 0.597917 -5.47855 +301 1 9.88178 10.3569 9.73038 4.79618 9.75255 -1.56513 +302 2 9.58096 11.2105 9.34815 0.270313 -13.7408 11.2463 +303 2 10.0884 10.4563 10.6769 -5.68787 3.60286 -6.41077 +304 1 9.72212 0.809424 10.8539 19.6856 13.2875 8.50656 +305 2 9.35568 18.6419 11.2241 -8.56647 -0.801274 -6.22283 +306 2 9.1718 1.19131 10.1642 -10.1616 -7.34852 -1.36201 +307 1 9.20808 15.1775 10.2123 -15.4381 -3.13199 6.73164 +308 2 8.85567 15.9769 9.80113 1.42232 -2.21967 -3.83769 +309 2 8.41617 14.6283 10.3808 11.8702 3.92611 -8.2586 +310 1 0.995689 9.3369 10.3259 -16.0333 -0.722577 -1.64132 +311 2 1.04111 10.3025 10.3672 11.5337 -2.90556 1.12718 +312 2 1.85551 8.94205 10.1494 2.50931 13.4523 1.23502 +313 1 16.8622 4.87275 8.19393 -0.422934 0.254968 7.2846 +314 2 16.1689 5.44633 8.57547 10.3862 -6.79292 -0.962882 +315 2 17.2033 4.29721 8.90095 -5.62498 7.92604 -8.45296 +316 1 14.656 14.7011 0.368319 0.981504 1.6367 -2.03469 +317 2 15.1464 15.0731 1.12238 -4.61865 -0.709772 -8.09446 +318 2 13.8079 14.3976 0.718239 6.88081 -1.79732 0.157513 +319 1 3.54139 11.054 9.61635 4.40574 2.25524 -6.23941 +320 2 3.65641 11.5568 10.4349 -3.33961 -4.79202 -0.629126 +321 2 3.06202 11.6341 9.00365 5.95536 0.511998 4.3162 +322 1 11.0657 10.8474 1.29636 2.92174 -3.12366 4.90686 +323 2 11.2982 11.6263 0.767958 -3.5102 -3.65436 5.75862 +324 2 10.1232 10.6698 1.15822 5.54645 2.63321 -1.67034 +325 1 13.2072 7.07995 12.8701 -0.715054 4.17079 -6.48984 +326 2 14.1512 6.89692 12.9697 -2.29399 1.70307 -2.36257 +327 2 12.7789 6.22148 12.7926 -0.519741 -2.64677 3.01569 +328 1 9.62848 1.89714 0.960589 0.144249 -1.27383 8.14422 +329 2 8.75389 1.7191 0.595255 2.62606 0.878667 -4.42234 +330 2 10.2646 1.96201 0.242782 -4.84565 1.17493 -5.89222 +331 1 10.5889 13.5223 4.7138 2.80012 2.67941 -15.7349 +332 2 11.4734 13.1444 4.59356 -4.0194 -1.02806 11.2737 +333 2 10.6142 14.0248 5.53615 3.92037 -3.05166 -0.671 +334 1 14.2891 1.71547 10.914 14.736 9.54636 -9.28817 +335 2 15.0906 1.40219 10.4788 -2.27816 -10.6125 3.67971 +336 2 14.438 2.66833 10.8812 -8.3278 1.7804 6.62982 +337 1 14.6539 12.3888 11.7057 -9.85382 -5.79197 9.84531 +338 2 15.5174 12.4906 11.2689 -13.4179 -5.72309 -9.10321 +339 2 13.9464 12.0325 11.1297 19.1264 4.07718 -1.67851 +340 1 8.24463 5.07042 9.80489 8.67652 16.3821 0.210642 +341 2 7.41075 5.25266 10.2586 0.116202 -10.888 -2.54867 +342 2 8.19641 4.23298 9.33202 -10.3006 -5.74151 5.58561 +343 1 1.57762 16.8331 18.335 1.68687 -2.26048 -0.033424 +344 2 1.80587 17.1847 17.4697 -0.252498 3.71983 1.68741 +345 2 2.01633 15.9753 18.3429 -7.29056 -3.61139 0.997127 +346 1 1.4432 17.2346 15.332 2.65894 -7.35401 -5.7102 +347 2 1.56202 18.0921 15.7447 -7.04866 6.37518 1.22888 +348 2 0.495246 17.0477 15.225 10.7628 4.03376 7.259 +349 1 3.71499 5.60328 6.17396 -2.46237 18.0728 1.59518 +350 2 3.14409 6.20568 6.67532 2.19379 -7.75625 0.984178 +351 2 4.32024 6.21155 5.72591 -1.08806 -7.05296 -5.84211 +352 1 12.3532 9.43776 14.1893 13.0079 -11.8089 -5.25996 +353 2 12.7562 8.63341 13.7793 -8.52026 15.4152 14.9752 +354 2 12.1872 9.21442 15.1219 0.0848175 -4.0166 -10.4276 +355 1 4.03165 15.279 6.91423 11.4052 5.55751 -7.84178 +356 2 3.54353 15.996 6.48767 -3.99323 -1.71496 7.04649 +357 2 4.96733 15.4866 6.74143 -6.91754 -4.3684 4.91577 +358 1 0.598678 8.56195 14.8837 5.20406 11.6905 0.774862 +359 2 0.593362 9.51845 15.0326 -4.59172 -3.85379 3.33684 +360 2 1.20863 8.47913 14.1435 0.530109 -4.80423 2.60663 +361 1 12.9822 8.33824 10.332 -12.7812 8.13505 -15.7365 +362 2 13.7449 7.91273 9.91994 1.65618 -4.07378 8.99333 +363 2 12.9305 8.07685 11.2552 9.52621 -6.7264 2.9301 +364 1 15.3077 7.66451 3.49902 -16.235 -26.2008 20.478 +365 2 14.5457 7.14577 3.24297 -4.72624 11.0142 -23.2354 +366 2 15.4625 7.21195 4.33822 21.3334 18.0327 3.91528 +367 1 17.3129 6.65992 0.0418436 1.52354 1.06354 -1.27952 +368 2 16.9014 5.84978 0.373955 -3.48337 6.90323 -1.87832 +369 2 16.58 7.23266 18.3971 4.62858 -6.17573 2.16922 +370 1 8.83009 6.92284 7.82744 0.252992 -5.92817 5.57761 +371 2 9.76137 7.15634 7.81451 4.22584 7.3373 -3.58966 +372 2 8.73794 6.33872 8.59756 -2.97854 -0.622916 -4.66555 +373 1 12.3396 0.625886 1.18148 -8.16379 -0.652746 9.01197 +374 2 13.1345 0.755236 1.71568 4.24005 -1.61972 -8.33969 +375 2 12.5055 18.5332 0.58867 3.80642 2.13695 -0.293066 +376 1 5.66619 15.1148 14.5143 -6.5884 11.0519 3.391 +377 2 4.74474 15.2404 14.7783 -0.0534379 -6.99417 -3.01637 +378 2 5.9729 15.9975 14.2655 4.1321 -4.56061 -2.72375 +379 1 3.84883 6.51764 1.70764 -0.24517 -12.2729 -5.84301 +380 2 3.34882 7.24325 1.31145 3.38543 6.95106 5.25371 +381 2 3.97654 6.73657 2.63696 -3.88246 4.168 -0.0932901 +382 1 3.88114 11.6142 12.2659 5.57001 4.81087 6.19714 +383 2 4.75444 11.9544 12.4977 1.45427 -2.38077 -3.49117 +384 2 3.27884 12.2304 12.6965 -5.21243 -4.02352 0.863052 +385 1 5.43603 3.86764 15.8623 7.54926 19.6814 5.52869 +386 2 6.13377 3.21124 15.7334 -3.30504 1.34649 -4.68995 +387 2 5.89589 4.73554 15.9355 -10.2176 -19.0214 -2.32011 +388 1 14.4546 10.3201 4.4055 -4.6195 -17.8145 -6.66778 +389 2 14.5894 9.8066 5.2203 1.29615 2.58376 -6.73886 +390 2 14.6351 9.71867 3.64602 0.226975 12.0799 18.4878 +391 1 7.91148 17.3357 9.20787 -1.7112 -7.64626 2.59046 +392 2 7.14677 17.4921 9.78359 1.89149 7.49144 -9.53339 +393 2 7.98506 17.9868 8.49476 -7.16328 0.988414 5.46347 +394 1 4.5072 14.4394 3.95775 1.71054 11.4257 7.67338 +395 2 4.60793 15.3916 4.19235 0.708777 -20.878 -0.615863 +396 2 4.75094 13.8726 4.71695 -2.09911 13.0171 -9.33913 +397 1 14.3103 7.38832 15.7657 0.217846 1.64546 9.18842 +398 2 15.2433 7.23588 15.5844 -0.0812074 1.42566 -0.574095 +399 2 14.3036 7.75428 16.6621 0.0607731 -0.988243 -5.21848 +400 1 2.8988 18.2304 1.89629 8.58281 11.0644 9.98123 +401 2 2.46496 17.5082 1.44481 -2.59003 -3.64619 -8.76243 +402 2 2.19471 18.7603 2.28641 0.940953 -0.0494932 1.95923 +403 1 7.97286 1.6093 4.54004 -3.7555 -8.8471 12.6183 +404 2 7.33734 2.04506 3.96057 8.79876 5.02214 -6.32296 +405 2 8.86006 1.965 4.43164 -2.78989 3.02833 -7.03085 +406 1 2.61876 14.1356 17.7492 -10.3822 -13.3904 -3.64852 +407 2 1.93119 13.4601 17.9363 9.46205 16.209 2.13837 +408 2 3.45643 13.7285 18.0162 -4.37303 1.24885 0.341178 +409 1 0.743255 1.70456 13.8731 3.59522 3.89384 -8.23695 +410 2 0.90651 1.38191 14.7629 -6.62821 1.47751 3.8543 +411 2 18.4338 1.82907 13.7582 5.96409 -0.15878 4.57237 +412 1 4.54424 18.6047 13.95 -3.57477 5.05027 -2.13798 +413 2 5.48468 18.3837 13.9843 -5.3566 -3.00882 -0.547935 +414 2 4.15141 18.3634 14.8001 4.77528 1.99072 0.545271 +415 1 7.0969 0.526127 18.3635 1.96349 3.45814 -4.17057 +416 2 7.27221 0.201121 17.4702 1.10961 -1.44826 4.33327 +417 2 6.13787 0.588122 18.4485 3.2238 7.1666 2.24 +418 1 16.0917 18.4266 14.1084 2.59329 0.57669 -10.3481 +419 2 15.3502 17.9157 13.7545 1.31994 6.64432 9.22997 +420 2 15.9271 18.7357 15.0116 -3.89333 -11.6647 -1.43214 +421 1 10.0733 4.52495 16.275 12.9842 -2.30982 2.85456 +422 2 11.0043 4.70153 16.4703 -2.64404 5.32532 -3.085 +423 2 10.0864 3.57376 16.1251 -6.72333 -0.470122 -1.54666 +424 1 15.8636 17.8904 4.42819 -6.03116 8.53171 5.31621 +425 2 16.3871 18.7073 4.48664 -0.23776 -8.88425 -2.03055 +426 2 14.9745 18.1441 4.72479 9.46919 -4.85854 1.60726 +427 1 6.9475 17.372 13.7315 15.8768 1.84738 17.2901 +428 2 7.36738 17.5483 14.6019 -4.78498 1.02898 -17.1267 +429 2 7.68915 17.2477 13.1142 -8.54431 1.43966 5.77183 +430 1 13.2923 6.53747 6.71701 -11.5961 -7.93952 14.6915 +431 2 14.1983 6.84596 6.64723 3.17712 4.25021 -11.0614 +432 2 12.8934 6.43009 5.84838 7.58936 1.28323 -8.80485 +433 1 7.69653 2.37351 9.2065 12.517 1.33593 -3.6252 +434 2 7.21057 2.29 10.0355 -5.39375 -0.506169 -1.44147 +435 2 7.12159 2.1318 8.46594 -3.32624 -2.43573 8.05936 +436 1 15.157 14.8759 13.6545 4.5209 -3.06988 2.24561 +437 2 15.0369 15.0852 14.5928 -3.37623 1.75424 -5.30162 +438 2 14.3708 15.1144 13.1546 1.18854 2.2818 3.55032 +439 1 9.31032 8.32311 3.71462 16.317 -0.492826 6.27183 +440 2 10.1522 8.77498 3.89843 -7.06732 -0.949504 -0.86517 +441 2 9.4815 7.39306 3.91425 -6.58464 2.05554 -3.01208 +442 1 17.7054 13.4931 16.4528 -2.79698 17.5255 -9.98682 +443 2 16.7518 13.3863 16.3682 2.15912 -8.30505 3.41837 +444 2 17.8443 14.3312 15.9805 5.97419 -5.13367 5.17943 +445 1 5.02162 10.6562 2.64136 -2.02283 -9.27068 2.47877 +446 2 5.69056 10.1772 3.15718 -2.95942 7.94984 0.663407 +447 2 4.59516 11.2797 3.2389 2.78246 -2.35968 2.10645 +448 1 3.7261 8.35111 10.2906 -2.0647 -5.12326 -12.4171 +449 2 3.87558 9.26669 10.0174 -1.23075 2.88832 6.28188 +450 2 3.61938 8.33938 11.2471 1.47542 3.72119 -0.959794 +451 1 16.077 7.09208 6.26442 0.512876 -15.8531 0.565556 +452 2 16.8498 7.55114 6.61759 -4.58181 2.74438 -1.19615 +453 2 16.2841 6.14901 6.36212 0.103861 8.35624 -6.71996 +454 1 15.1586 7.03156 9.12145 1.35056 8.00181 -20.3615 +455 2 15.9739 7.38238 9.50783 -5.19642 1.69713 -0.962803 +456 2 15.0724 7.48187 8.24992 4.14438 -5.93719 19.2407 +457 1 6.4279 13.1173 12.8809 -5.50985 -11.8139 -9.3985 +458 2 7.12916 12.5687 13.2568 1.68182 7.24531 -2.67671 +459 2 6.29661 13.8986 13.4214 -0.338885 -0.946459 7.65298 +460 1 12.1214 4.48617 13.0834 13.9874 7.50725 -12.3985 +461 2 12.203 4.65044 14.031 -7.85782 -1.77094 2.73271 +462 2 11.2673 4.11709 12.8488 -4.68474 -5.36964 10.3853 +463 1 11.3361 8.19542 7.84742 15.1179 -11.1226 16.1752 +464 2 12.0446 7.62229 7.53485 -1.89389 0.170875 -13.8157 +465 2 11.6069 8.28902 8.77112 -9.48953 8.11742 -0.143346 +466 1 17.184 10.7876 7.43369 13.5323 -0.921102 -17.174 +467 2 17.9233 10.1981 7.20811 -10.1233 -1.22821 11.3165 +468 2 17.1161 11.3267 6.63249 -5.49276 7.55364 9.36769 +469 1 5.23991 18.1348 11.0582 -10.3762 -3.21686 -5.77572 +470 2 4.63631 17.985 11.8048 7.12888 1.45886 -5.61107 +471 2 4.69408 18.0516 10.2533 5.93648 2.65605 9.16476 +472 1 7.56507 17.5919 1.8299 2.38736 9.59194 1.23507 +473 2 7.95273 16.7967 1.45285 -6.05148 -1.8022 -9.76241 +474 2 7.59068 18.2848 1.14776 -2.89899 -11.2976 1.8216 +475 1 1.88529 12.921 13.6059 -1.54804 -3.98178 5.6231 +476 2 1.43748 12.3178 14.2147 5.26513 0.934067 -3.79148 +477 2 2.14524 13.6768 14.146 -0.717118 1.88599 -5.70238 +478 1 9.71545 6.78651 14.8047 -15.2171 15.1422 7.50698 +479 2 9.90531 5.90708 15.1331 4.86835 -12.5985 -3.10865 +480 2 10.0627 6.91606 13.92 3.16992 -4.80507 -4.41639 +481 1 15.2317 4.3547 10.7806 -19.2619 -13.8042 -17.3299 +482 2 16.1692 4.17769 10.7161 9.63774 3.67614 12.8518 +483 2 15.0389 5.06132 11.3962 11.3469 5.0749 6.12787 +484 1 11.2086 6.13697 0.180528 -13.4008 -14.4307 -10.9666 +485 2 11.2654 5.18187 0.0337896 12.1183 5.06406 4.26486 +486 2 10.2799 6.29806 18.6081 2.85376 11.1709 5.84358 +487 1 0.155975 11.3317 15.1259 -12.2739 12.4049 -22.3111 +488 2 18.2869 11.6878 14.3448 9.29886 -6.35489 23.8975 +489 2 18.7388 12.0248 15.8046 -8.78344 -4.02614 -5.34871 +490 1 7.07225 9.17108 7.27057 -4.95781 3.28344 -6.42365 +491 2 6.44778 8.45946 7.46529 5.34767 -0.253084 5.87629 +492 2 7.94637 8.76128 7.25029 -3.14507 0.531691 2.27088 +493 1 18.4147 15.4309 12.3592 -5.86353 -0.606553 -5.09086 +494 2 0.72281 15.5186 12.2612 4.29187 -2.85716 2.67478 +495 2 18.0791 15.7216 11.5043 -3.32345 0.421348 1.66841 +496 1 16.5543 4.36503 5.23509 20.0373 -2.39618 26.5758 +497 2 16.7455 4.21973 6.1845 -16.121 -2.23612 -11.2684 +498 2 17.4558 4.42117 4.89188 -6.1573 5.26009 -14.9538 +499 1 17.766 3.07261 10.7271 -5.62269 10.8805 -1.85707 +500 2 0.0408353 3.2985 10.945 -3.12308 -7.03453 -2.35326 +501 2 17.719 2.23067 10.252 6.41295 1.44898 4.1666 +502 1 12.3026 0.0397215 10.1517 -5.9029 17.7484 6.25384 +503 2 11.458 0.404705 10.4688 2.82225 -9.87605 -6.68676 +504 2 12.8944 0.808865 10.1781 1.22751 -9.09827 -0.112681 +505 1 10.357 9.81077 12.3435 10.1956 0.0137966 -0.104503 +506 2 11.132 9.85287 12.9219 -4.83247 1.57396 1.64677 +507 2 10.2731 8.87192 12.148 -4.78867 -1.2901 1.32484 +508 1 0.505846 2.83821 7.01562 3.91094 -2.13436 13.3247 +509 2 0.681162 3.5182 7.67504 1.89272 4.99945 -7.1411 +510 2 0.694039 2.0503 7.53478 0.801338 -5.04329 -7.26695 +511 1 0.437103 15.2686 6.90942 10.3075 -26.8847 6.28938 +512 2 0.575652 15.2733 7.87231 -4.50905 3.86257 -7.07916 +513 2 0.764375 14.3681 6.66626 -11.1886 22.2654 -1.84191 +514 1 16.9895 7.01682 15.3107 -21.8777 2.45652 -5.46979 +515 2 17.7216 7.6089 15.1142 9.4824 -7.00642 -0.959024 +516 2 17.2645 6.09907 15.4073 14.9833 2.67634 2.96399 +517 1 9.01274 12.4171 8.12853 10.6441 15.1284 15.6095 +518 2 9.41612 11.8292 7.47716 -12.8498 -4.61215 -9.56742 +519 2 8.05003 12.5053 8.0704 6.97129 -9.84551 -10.1137 +520 1 1.26391 1.92336 3.04659 2.32337 -11.3487 -0.982019 +521 2 0.972058 2.42084 2.27545 2.43588 3.35199 3.68236 +522 2 1.90572 2.43981 3.5544 -5.46738 3.49891 -6.33947 +523 1 4.13143 15.1122 9.67174 -10.3949 2.47722 13.8895 +524 2 4.06276 15.2642 8.72313 5.39511 -1.60046 -0.0768584 +525 2 4.99495 14.7433 9.87874 3.88633 -1.07729 -6.21534 +526 1 7.19145 2.18155 14.5787 4.86443 0.520714 0.489557 +527 2 6.89453 1.81445 13.7426 1.87671 -5.23084 1.53267 +528 2 7.73681 2.92919 14.317 0.289792 2.5421 2.67041 +529 1 18.6 14.6947 2.16091 -2.26171 3.41683 0.482467 +530 2 0.820032 15.117 2.19003 5.03273 -5.31768 -1.38278 +531 2 17.9827 15.4314 2.17519 -7.65677 -2.44766 2.74205 +532 1 9.95161 2.77613 12.9401 9.45852 -1.28953 0.462065 +533 2 9.84872 2.18467 12.1812 -5.82301 1.90383 1.05008 +534 2 9.27924 3.46642 12.8986 -6.28602 -3.28272 -2.83121 +535 1 2.83159 8.92314 13.0298 -5.32883 -6.03653 -2.71455 +536 2 3.23927 9.77312 12.842 3.02047 6.8466 -0.359778 +537 2 3.51958 8.34046 13.3637 5.40811 -1.61307 4.23789 +538 1 3.22435 8.37789 3.65229 -1.03338 2.31116 19.4552 +539 2 3.68753 9.01983 3.09696 -0.346577 4.63804 7.35474 +540 2 3.38788 8.57936 4.60408 0.951973 1.27409 -22.7571 +541 1 5.6137 7.19416 8.52025 7.21613 5.80474 -6.44533 +542 2 5.78863 6.24316 8.52523 -9.99458 0.454093 3.85202 +543 2 5.0179 7.43184 9.24037 0.527922 -7.72891 3.36669 +544 1 14.8805 1.29251 2.00129 6.0675 21.6566 -5.88084 +545 2 14.8065 2.10545 2.50153 -6.7285 -1.94379 16.9269 +546 2 15.1655 1.66296 1.16284 -0.437229 -14.9075 -12.229 +547 1 8.26451 15.1933 0.836486 3.22704 -2.0235 12.9462 +548 2 8.92324 15.2163 1.54184 12.9519 -3.35665 -8.03315 +549 2 7.55879 14.6837 1.25205 -6.95241 0.364363 -7.46808 +550 1 15.625 1.34415 7.23495 -17.3283 -0.11068 -5.87671 +551 2 14.9596 0.769214 6.81661 10.6011 2.38946 3.65492 +552 2 15.1493 2.17629 7.38417 4.13791 -2.68619 2.35471 +553 1 4.93041 13.0764 18.5264 9.84655 1.48115 -2.02825 +554 2 5.35318 13.1968 0.744685 -3.49153 -1.64799 -2.34468 +555 2 5.56664 13.4414 17.8965 -2.33559 -1.35641 1.38511 +556 1 15.3557 8.48379 18.1448 0.204246 14.4785 -5.82183 +557 2 15.7265 9.09289 17.4831 -0.830936 -8.68367 1.885 +558 2 15.168 9.07051 0.245745 1.7123 -4.50429 2.39894 +559 1 12.0892 3.02993 18.3645 -15.9576 34.4498 -4.49703 +560 2 11.9769 2.60431 0.571005 13.6468 -16.1673 -1.05926 +561 2 12.5269 2.48004 17.7153 4.47893 -15.6345 5.41851 +562 1 13.2117 12.674 5.1931 -10.339 11.1011 -13.5125 +563 2 13.668 11.9204 4.80624 6.1285 -2.92776 7.79567 +564 2 13.4681 12.7869 6.11335 2.67539 -7.97004 0.458585 +565 1 6.0506 7.06933 0.0406962 1.31452 -3.72946 4.6718 +566 2 6.04306 7.98784 18.9476 0.374235 14.6189 -4.65006 +567 2 5.24553 6.71887 0.435288 -0.866845 -3.58603 0.782556 +568 1 17.739 15.9899 15.0125 -12.5206 6.16285 -12.4036 +569 2 16.945 16.5161 15.03 -7.46495 5.1976 21.0221 +570 2 17.8264 15.955 14.0627 17.7161 -15.0875 -11.5838 +571 1 13.1794 1.00208 16.5735 3.37979 -5.34722 -6.70143 +572 2 14.139 0.860857 16.6169 -5.21536 -1.33728 6.50102 +573 2 12.8035 0.137283 16.3512 2.48828 2.22182 6.02943 +574 1 11.096 14.5828 7.22348 0.0189977 4.74793 7.83345 +575 2 10.4045 14.1614 7.73717 -8.54387 -1.14011 0.371667 +576 2 11.8979 14.1335 7.50232 3.58446 -6.30574 -4.63725 +577 1 17.5104 8.62105 2.08846 14.2737 4.97696 2.51664 +578 2 16.6904 8.42754 2.54903 -5.27316 -4.4343 -3.04137 +579 2 17.6167 7.98338 1.37729 -7.36397 -7.55614 -1.26172 +580 1 12.3515 7.96855 1.99107 6.37927 0.258975 7.77687 +581 2 12.1159 8.90068 1.90258 -3.43959 -5.51169 -5.98444 +582 2 11.9581 7.4701 1.26507 -2.67829 1.90847 0.988543 +583 1 11.8954 14.6159 10.3514 1.85125 4.19108 3.73581 +584 2 12.1615 13.856 9.81631 -7.50724 5.70574 2.33101 +585 2 10.9524 14.815 10.2079 9.27078 -9.38408 -0.682121 +586 1 6.88225 7.03081 15.6002 -4.063 -7.66118 -6.77733 +587 2 7.75096 7.17076 15.1857 -5.63662 2.89282 10.0227 +588 2 6.77779 7.6167 16.36 6.70206 0.515961 -5.66863 +589 1 8.00078 4.70171 13.472 -1.59283 -4.83357 -4.64481 +590 2 7.27623 4.81783 12.8396 5.32657 -1.99722 0.885811 +591 2 8.48998 5.527 13.4768 -0.383179 2.4117 0.469228 +592 1 13.3975 12.1709 14.2706 1.21587 3.44049 5.53322 +593 2 13.2724 11.2098 14.2197 -1.68144 4.93388 -3.39254 +594 2 13.8611 12.4606 13.4725 -0.646036 -5.76058 -0.123004 +595 1 14.8166 9.4384 7.29692 -7.31149 -4.84482 -6.71483 +596 2 15.6063 9.98387 7.39943 -3.2576 1.32409 4.65546 +597 2 14.0612 9.86586 7.70853 4.31514 4.68737 1.52589 +598 1 12.6657 17.0265 3.08863 -0.499632 18.4226 10.5493 +599 2 13.0409 17.4141 3.89779 -4.03665 -9.69042 -5.1428 +600 2 12.0457 17.7132 2.78031 5.51866 -13.6109 -0.0343421 +601 1 1.16791 7.14337 17.4519 -17.3777 -0.471365 -9.17207 +602 2 0.285968 6.88879 17.7816 4.71885 8.57951 0.206219 +603 2 0.996987 7.64547 16.6337 5.09703 -7.79381 5.85561 +604 1 12.7928 5.13809 15.6672 21.9233 -6.79759 1.12632 +605 2 13.5314 4.49934 15.6812 -12.3388 3.06691 0.377185 +606 2 13.2535 5.99313 15.6546 -7.1176 -2.71451 -0.771614 +607 1 2.50804 3.40102 5.01245 -9.19737 1.42964 37.6951 +608 2 1.85734 3.08405 5.69632 14.2768 7.06331 -19.9109 +609 2 3.04485 4.07021 5.49582 -10.9118 -9.07044 -17.2872 +610 1 8.33238 11.2579 13.4651 -31.1482 13.4197 6.60268 +611 2 8.24927 11.0816 14.4232 19.8118 -8.42601 -14.5581 +612 2 9.11403 10.9307 13.0113 5.91799 -11.9552 15.0186 +613 1 12.8978 1.37199 13.3367 -3.68795 11.8567 -21.2004 +614 2 13.3586 1.33808 12.4821 5.12584 -5.42725 10.3839 +615 2 12.3812 2.18266 13.2296 0.582289 -3.8456 10.447 +616 1 6.35916 13.6786 2.13932 11.022 -2.36774 12.7417 +617 2 5.81416 14.065 2.83164 -5.92624 2.48265 -4.44044 +618 2 6.97105 13.1303 2.64934 1.90703 -2.61302 -7.4669 +619 1 15.9256 6.59608 12.7788 -4.50753 -7.00075 -5.11208 +620 2 16.441 7.14613 12.1828 -0.0403293 3.27533 -1.15613 +621 2 16.337 6.66123 13.6439 3.64448 2.92523 3.21919 +622 1 16.8436 0.710185 9.59384 -10.8386 -3.59173 0.641976 +623 2 16.678 18.424 9.8391 7.1202 6.86076 -6.23598 +624 2 16.34 0.863872 8.77611 6.63769 -2.37412 0.960785 +625 1 6.14874 11.7365 8.37914 -9.33508 -33.9533 -7.34454 +626 2 5.23473 11.5355 8.67103 13.3879 7.28881 -1.35634 +627 2 6.50048 10.8558 8.08418 -3.72877 24.3898 8.07481 +628 1 2.86629 8.64627 0.414665 29.1459 -9.93647 1.24251 +629 2 2.37091 8.1673 18.3782 -14.09 11.8062 8.4924 +630 2 2.39345 9.32329 0.907466 -18.2396 -1.77699 -9.50941 +631 1 10.1496 10.4602 6.51654 2.68196 -4.3054 1.18084 +632 2 10.6351 9.79475 7.02051 -3.21697 0.687034 0.899044 +633 2 10.5797 10.4719 5.65285 -1.94715 4.18574 1.72512 +634 1 6.74842 15.6916 6.55665 -2.66838 16.8954 6.36263 +635 2 7.13132 16.1354 7.32023 -0.325366 -7.45035 4.57015 +636 2 6.8063 16.3799 5.88394 5.31174 -8.689 -7.83261 +637 1 6.45137 13.1469 5.60457 -4.49761 -5.86725 0.527716 +638 2 6.60666 13.9979 6.03098 2.95924 -2.27328 1.19215 +639 2 5.97977 12.5923 6.23705 2.74812 2.58161 1.74453 +640 1 16.8067 12.5538 9.81832 0.32671 -4.80998 5.18546 +641 2 16.9975 11.894 9.13199 -1.38663 9.72579 -2.40586 +642 2 16.8023 13.4365 9.43343 1.83869 -5.34542 -5.01893 +643 1 6.05747 2.94525 2.83457 1.69886 0.640591 -2.15275 +644 2 6.28227 3.83854 2.57267 5.15417 9.09864 3.82618 +645 2 5.67557 2.57416 2.03485 -2.61266 -9.3622 -0.552159 +646 1 10.8942 3.30264 3.28891 6.21412 -5.01644 3.41466 +647 2 10.2824 3.98758 3.58006 -2.01501 -0.119341 -5.67488 +648 2 10.543 2.90591 2.48434 -5.60317 1.35459 0.297545 +ITEM: TIMESTEP +30 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.7097 7.05343 17.9609 20.7509 -2.32452 -4.15205 +2 2 7.78893 6.94819 18.1674 -15.0431 -3.26874 3.90688 +3 2 8.91258 6.41114 17.2706 -4.14568 0.140094 0.745653 +4 1 18.6207 8.28878 6.84456 -10.9758 14.7568 -16.4597 +5 2 0.033254 8.12327 5.87995 7.78297 -6.3031 11.7942 +6 2 0.390602 7.58629 7.343 9.14113 -10.4614 1.3502 +7 1 8.4202 18.5906 6.81681 -12.3331 6.77681 2.70587 +8 2 9.32414 0.194792 6.65918 12.4366 2.53215 -2.1327 +9 2 7.89923 0.683074 6.46691 2.1768 -2.64942 -1.08929 +10 1 6.58134 1.82408 11.6823 -18.6778 6.99539 14.5251 +11 2 5.88329 2.28495 12.2086 12.5233 -11.9933 -14.8966 +12 2 6.20729 0.949756 11.4934 -0.484037 1.974 1.03676 +13 1 7.10261 5.71907 2.36398 18.2567 -30.46 4.77574 +14 2 6.748 6.26194 3.05915 -16.1408 13.0855 0.817955 +15 2 6.89353 6.07497 1.50557 -7.56713 14.4666 -6.71064 +16 1 16.2146 10.1912 16.1045 25.8326 -16.9059 -6.28167 +17 2 17.1924 10.2614 15.9892 -26.0275 4.96146 3.01812 +18 2 15.8649 11.0425 16.3511 -1.01593 12.6392 3.03555 +19 1 10.6309 14.9782 2.32852 5.54907 12.6484 -4.66534 +20 2 10.5683 14.607 3.21596 0.623447 -1.40903 0.430751 +21 2 11.0949 15.8303 2.43151 -6.58286 -12.6372 2.6945 +22 1 17.1592 8.25618 10.4876 -10.0218 -2.97818 8.46282 +23 2 16.7485 8.99843 10.9576 2.65758 -6.15573 0.24812 +24 2 17.9939 8.575 10.1448 6.84049 6.50961 -0.847785 +25 1 14.8275 15.8902 16.3678 -10.7483 8.55828 -7.5541 +26 2 13.911 16.2262 16.382 8.40977 -5.5752 2.0788 +27 2 14.9328 15.3229 17.136 -2.68587 0.983086 7.72287 +28 1 12.1445 13.398 0.450021 7.16446 -9.51802 2.88894 +29 2 12.0254 13.4023 18.1304 -4.57533 9.09159 6.34311 +30 2 11.5749 14.0284 0.911779 -3.72154 -0.858053 -5.79964 +31 1 9.27791 5.43254 4.03115 12.5872 2.27984 -15.9713 +32 2 8.88042 5.04351 4.80522 -11.7175 -1.93285 8.71688 +33 2 8.63164 5.36398 3.31053 -0.238489 1.95718 4.1093 +34 1 1.81582 4.23406 11.6392 3.52665 -33.0533 9.77708 +35 2 1.78778 5.15359 11.8657 -3.54286 18.5189 3.84305 +36 2 2.12638 3.75505 12.4373 -4.00166 7.6753 -17.1576 +37 1 1.99877 6.82017 8.35649 4.97761 -1.46296 10.7796 +38 2 2.31944 7.23424 9.17304 -0.0326511 4.09138 -10.3959 +39 2 2.07937 5.88268 8.56766 -7.36821 -1.33929 -3.79841 +40 1 5.395 4.41162 7.94446 4.05063 -3.43427 6.53634 +41 2 5.41133 3.44966 7.94196 6.73946 -4.4132 0.768998 +42 2 4.74595 4.62804 7.28165 -7.35272 12.6119 -8.90882 +43 1 3.28409 2.93052 17.527 4.91883 3.31559 -8.51102 +44 2 3.97895 3.44036 17.0791 -2.08356 -9.03714 -1.68785 +45 2 2.70652 3.59221 17.9099 -2.28402 5.9437 7.00724 +46 1 7.47067 5.28165 6.09824 -7.47353 5.76211 -2.63966 +47 2 7.88561 6.05707 6.46631 15.843 7.70036 2.30241 +48 2 6.86027 5.05727 6.79609 -9.98425 -16.5426 3.24835 +49 1 9.77462 7.02047 11.9927 -3.16333 0.34511 -3.92757 +50 2 10.3836 6.39122 11.588 -5.90607 3.51948 -2.51732 +51 2 9.0529 7.19715 11.3548 12.4276 -3.26368 6.69514 +52 1 14.0466 3.57679 8.07144 18.6703 -0.348541 19.5758 +53 2 13.8937 4.22019 7.39343 -5.64007 13.0869 -9.16622 +54 2 14.611 4.0279 8.7381 -15.3074 -10.3909 -10.441 +55 1 4.67183 17.2138 3.98342 -17.1629 -17.7927 10.2823 +56 2 5.57476 17.4036 4.21567 13.953 12.775 -5.74716 +57 2 4.34342 17.7474 3.25626 2.59666 4.69733 -2.98879 +58 1 16.5112 16.6016 10.1232 -22.4077 14.5184 19.5552 +59 2 15.797 16.9077 10.7255 16.9762 -11.2391 -6.18282 +60 2 16.019 16.127 9.45142 2.29692 -6.2585 -6.10264 +61 1 1.96965 4.87893 0.40906 -10.7697 -8.55226 -4.93465 +62 2 2.66061 5.27529 0.941341 5.5274 3.49831 6.88318 +63 2 1.47511 5.62215 18.6951 6.32177 2.44726 -2.78863 +64 1 11.7331 13.3335 16.3023 -6.06186 -8.167 -3.78825 +65 2 11.2597 12.4992 16.3612 -10.498 -1.32756 10.0093 +66 2 12.2577 13.1697 15.5177 8.21427 7.2284 -4.69488 +67 1 10.121 11.0486 16.9167 -7.88764 10.2638 -1.90592 +68 2 10.5124 10.1783 16.9786 2.49636 -9.86729 -0.127492 +69 2 9.16626 10.9164 16.816 6.71354 -1.99355 -1.80005 +70 1 11.7161 17.4964 13.4564 0.653858 7.10726 11.4031 +71 2 12.4343 17.1488 12.9211 3.60089 1.57548 -4.57497 +72 2 11.8646 18.4589 13.5472 2.97554 -11.89 -7.13537 +73 1 6.3779 9.31416 12.2259 -8.95234 15.1635 22.3379 +74 2 6.77463 8.98312 11.4273 14.2971 -1.19702 -8.86117 +75 2 6.96666 9.97806 12.6372 -2.9053 -11.0825 -10.5803 +76 1 16.2282 12.7644 2.6938 13.255 22.6007 -2.42149 +77 2 17.0484 13.1981 2.39924 -4.54016 -10.6437 3.48813 +78 2 15.6471 13.522 2.85837 -6.5992 -7.46489 -1.32569 +79 1 0.640508 12.5852 5.88727 21.753 -1.83143 4.54161 +80 2 0.997304 12.3975 5.01963 2.04371 1.22983 -7.11515 +81 2 18.3646 12.7399 5.72186 -19.0302 3.73655 0.683884 +82 1 5.21387 16.4194 18.454 4.66732 -1.11443 8.72996 +83 2 5.89359 15.806 18.1817 0.824082 -8.56943 -13.0935 +84 2 5.59435 16.7978 0.603858 -5.48698 7.00748 3.62952 +85 1 0.548987 7.64401 4.10842 0.670348 4.32997 2.73018 +86 2 18.6015 7.92625 3.40384 -3.24873 3.72744 -1.92559 +87 2 1.36738 8.12724 3.94642 3.53853 -5.18785 -2.83474 +88 1 3.12734 8.93117 6.50347 30.4123 1.43415 3.20415 +89 2 3.68489 8.55498 7.21169 -11.4249 4.27745 -10.9708 +90 2 2.23185 8.74841 6.74202 -19.2185 -4.73256 7.28786 +91 1 7.31515 10.3274 16.2171 -7.5998 2.86538 3.08356 +92 2 6.58991 10.5191 15.6248 2.07633 0.375924 -7.53004 +93 2 6.86928 10.3012 17.0718 3.58834 -2.41696 5.50844 +94 1 11.1056 1.03439 5.00906 5.66297 2.87297 -9.25474 +95 2 11.3082 1.81468 4.47889 -2.42802 6.95123 8.17266 +96 2 10.7866 0.43271 4.33294 -5.36858 -10.0003 1.63315 +97 1 4.38851 2.75082 13.2055 -1.16421 16.6802 -23.4007 +98 2 4.78143 3.22961 13.9394 0.315345 -9.27332 13.6616 +99 2 4.20912 1.83275 13.4212 4.21877 -6.70893 11.8835 +100 1 8.39225 10.0828 1.81263 -0.204034 19.0364 -5.60934 +101 2 8.35289 10.7959 2.47026 -1.38438 -3.08289 -2.87504 +102 2 8.81547 9.35618 2.25702 3.41266 -13.1645 6.66357 +103 1 10.4926 1.73671 15.571 11.1439 -7.64614 -12.2914 +104 2 11.3949 1.40928 15.4244 -6.59208 6.73213 11.009 +105 2 10.2461 2.06593 14.699 -6.9068 1.71228 -0.826453 +106 1 2.72763 12.9186 7.78215 1.53907 -1.41162 9.17357 +107 2 3.36352 13.5565 7.43734 -3.21302 -0.65885 -4.12251 +108 2 2.22004 12.5809 7.03913 -2.76352 5.50699 -3.09439 +109 1 3.68558 11.672 5.21041 4.08504 4.36046 -3.38247 +110 2 3.45481 10.9554 5.79468 0.598863 -9.40064 6.30918 +111 2 2.92113 11.7973 4.6466 -2.33635 3.52119 -7.07475 +112 1 6.80415 14.4796 16.8864 5.34146 -11.2852 2.95693 +113 2 7.68462 14.091 16.8709 -3.70601 4.15103 0.993665 +114 2 6.49099 14.4407 15.9783 -2.62919 9.78665 -2.68056 +115 1 14.176 14.5561 3.39307 -12.5209 -3.15767 3.59597 +116 2 13.6245 15.3467 3.3085 5.15733 -4.43597 -5.06132 +117 2 13.635 13.92 3.89178 10.6994 6.10439 -0.0738324 +118 1 8.31018 18.1523 16.0453 25.0942 2.73084 1.98444 +119 2 8.89462 17.4796 16.3723 -6.95894 -25.3404 9.38217 +120 2 8.98968 0.119946 15.7574 -11.3153 21.4924 -7.69748 +121 1 4.73581 1.63729 4.92804 -12.581 -10.4736 11.5054 +122 2 3.83953 1.97889 4.8343 1.42607 1.89675 3.67103 +123 2 5.27039 2.18299 4.37483 11.2234 12.2757 -18.577 +124 1 15.0504 12.7475 16.4383 22.4341 -19.9388 -26.396 +125 2 14.708 13.1949 17.1966 -19.6268 9.49299 12.0559 +126 2 14.4413 12.6723 15.6738 0.429593 5.89098 19.3668 +127 1 15.7794 18.4162 16.8297 -23.8108 0.224717 -24.365 +128 2 16.2557 18.6157 17.6209 13.9809 -1.68 17.1984 +129 2 15.4229 17.5182 16.8969 9.44127 2.10519 2.83182 +130 1 1.1656 1.1613 16.5455 9.88565 -3.33075 -8.05438 +131 2 1.89055 1.78579 16.6066 9.02992 -0.102422 -1.61706 +132 2 0.673214 1.35844 17.3295 -13.4515 3.62078 11.8035 +133 1 18.1028 4.54571 15.8941 -4.73113 6.48399 7.96005 +134 2 18.5013 4.04336 15.196 5.27298 -10.1152 -10.2677 +135 2 18.7433 4.58481 16.606 1.22293 0.259147 -1.01212 +136 1 12.236 16.9836 16.146 14.9412 3.5391 -27.9779 +137 2 11.6416 16.3841 16.5672 -17.548 -8.54782 13.2608 +138 2 12.0887 16.8479 15.1863 -0.907912 9.23395 13.7712 +139 1 15.9498 2.53257 18.0253 10.6473 -13.6828 8.83411 +140 2 15.5627 3.24781 18.526 -5.22656 12.7326 -1.10284 +141 2 15.751 2.68965 17.0989 -3.04742 3.76351 -4.61681 +142 1 6.7038 13.8197 10.2271 2.9338 -17.2727 -3.34939 +143 2 6.61667 13.5512 11.144 -2.24755 5.72821 7.93099 +144 2 6.68776 12.9653 9.76874 -1.43812 10.35 -6.56898 +145 1 10.1318 18.2649 2.7724 -13.411 -9.16786 2.85058 +146 2 10.3828 0.244178 2.09267 2.54842 10.4954 -6.81354 +147 2 9.19143 18.056 2.59362 16.7762 1.59207 3.74676 +148 1 2.99108 17.7409 6.10283 23.0954 -1.76337 16.2177 +149 2 2.19234 17.7622 5.58671 -8.31269 -3.84851 -15.8536 +150 2 3.76803 17.7869 5.51609 -16.1123 2.00349 -4.76697 +151 1 12.5756 16.9274 7.99763 -5.18448 9.92793 0.0594024 +152 2 11.7822 16.4009 7.94219 -1.30832 -15.7704 -9.09049 +153 2 12.3073 17.5896 8.63909 10.7698 6.45321 6.22995 +154 1 14.8838 15.2691 8.24901 11.9288 7.15592 -19.4456 +155 2 14.3219 16.0313 8.11935 -17.9047 1.82161 10.6012 +156 2 15.419 15.3185 7.43747 0.964457 -9.38205 7.76842 +157 1 17.6242 18.2515 0.369787 17.475 26.3316 2.73311 +158 2 18.5101 17.9713 0.0958777 -8.0951 -12.2782 0.813683 +159 2 17.7821 0.518901 0.686034 -9.22006 -13.9572 -3.22273 +160 1 0.867554 10.3913 1.38534 13.3292 31.3771 -20.1166 +161 2 0.0708789 9.90853 1.49908 -23.2341 -17.8443 11.3974 +162 2 0.609768 11.125 0.785047 6.92113 -8.95227 10.8017 +163 1 1.63658 12.2225 3.36866 -7.99561 -17.8946 -31.9552 +164 2 1.35203 11.5128 2.74742 7.334 6.03534 21.6261 +165 2 1.63695 12.9742 2.77054 4.15295 9.67724 10.1418 +166 1 0.571199 17.2371 4.87124 -14.5407 6.59112 32.0774 +167 2 -0.059088 17.9662 4.92138 6.12201 4.50556 -13.0577 +168 2 0.445901 16.8548 5.75927 11.2459 -10.7393 -14.745 +169 1 1.10756 0.954018 9.42478 -6.01064 0.927768 -12.2971 +170 2 1.20282 0.614567 10.324 -1.80966 -3.76099 -1.37067 +171 2 0.239583 0.659806 9.09473 9.24115 0.27684 10.6776 +172 1 16.7657 2.33783 13.2856 -4.77092 -12.7415 18.4331 +173 2 16.9235 2.53629 12.3736 4.43968 6.32108 -18.3535 +174 2 16.5017 1.40258 13.3145 0.84997 6.98888 1.09187 +175 1 2.55595 15.84 12.1915 -9.99296 7.89206 -20.2214 +176 2 3.13585 15.4219 12.8083 9.49953 -6.79049 14.4751 +177 2 2.92245 15.6515 11.3148 -0.922807 -1.51117 1.32599 +178 1 16.4223 15.613 5.98575 -3.71667 -18.1819 11.7841 +179 2 17.3247 15.5921 6.33835 -0.216171 6.69275 -4.6749 +180 2 16.2529 16.4332 5.52058 8.23488 6.69239 -4.77655 +181 1 5.80627 5.05529 11.7835 2.20346 1.03406 8.57972 +182 2 5.47099 5.61389 12.5063 0.21977 1.29573 -10.4635 +183 2 5.43215 4.18052 11.9366 -3.48089 3.11082 -1.53573 +184 1 15.1897 4.8564 0.727292 -5.49239 9.65996 -2.72664 +185 2 15.2051 4.71263 1.67299 -4.1535 -7.09946 8.01526 +186 2 14.3467 5.30742 19.2217 7.5675 -5.77492 -4.69919 +187 1 16.3443 16.3423 2.09898 -10.6702 -0.501744 21.7899 +188 2 16.0343 16.7391 2.94116 7.72577 -10.997 -12.8868 +189 2 16.4832 17.1019 1.54751 7.961 8.6491 -12.4493 +190 1 0.271558 4.86315 3.80356 2.16636 -31.8967 4.70784 +191 2 0.500225 5.77685 3.71679 7.2244 19.9811 4.59738 +192 2 1.02077 4.40389 4.23265 -9.838 12.5034 -4.93629 +193 1 2.94659 15.0442 15.0679 0.642608 -6.50925 -4.27186 +194 2 2.75789 14.5701 15.8868 0.637625 5.4096 6.54553 +195 2 2.48063 15.8876 15.1248 -0.665005 -3.22304 2.52721 +196 1 1.13823 14.625 9.55769 -40.6641 2.98648 23.3687 +197 2 1.89308 14.4183 9.03602 24.2615 -17.8348 -5.78778 +198 2 0.899054 13.8694 10.146 16.149 11.9497 -18.7143 +199 1 13.6328 16.6228 11.5317 -8.77554 -4.828 10.6654 +200 2 13.2136 17.4084 11.1616 -1.58446 0.630618 -8.00902 +201 2 13.0391 15.8864 11.302 7.59245 3.60181 -7.14688 +202 1 4.70114 1.47286 0.734685 -3.14847 1.30924 1.42089 +203 2 4.10181 2.05657 0.255283 4.3012 0.912352 -3.9516 +204 2 4.12143 0.893804 1.23429 -1.01367 -7.44934 0.356301 +205 1 1.44259 18.5254 11.8725 4.87725 -20.5249 2.38925 +206 2 1.2982 0.329643 12.7089 -1.92821 4.76162 2.3937 +207 2 1.66413 17.5975 12.0994 -0.659414 17.7173 -3.45023 +208 1 11.5206 10.1171 4.06393 -3.80452 1.00663 -6.51606 +209 2 11.2843 10.553 3.23019 1.0155 -1.19537 2.23558 +210 2 12.4827 10.1039 4.08159 3.36054 1.41703 2.51077 +211 1 8.33991 12.1729 3.71569 5.40649 2.32091 -9.4304 +212 2 9.08268 12.7024 4.00206 12.7546 1.78956 -5.29094 +213 2 7.80528 12.1916 4.49536 -21.4073 -3.06625 11.8611 +214 1 14.3677 4.01314 3.28101 5.46562 4.88363 2.56432 +215 2 15.0857 4.19963 3.89805 0.543674 -3.28085 4.74869 +216 2 13.622 4.5498 3.58084 0.572713 -1.66955 -3.63784 +217 1 5.59145 1.71061 7.51389 3.0333 8.44076 -17.8773 +218 2 4.93757 1.09228 7.83941 -4.88752 -5.30351 6.58254 +219 2 5.37448 1.80426 6.56172 4.34195 -4.37145 14.4788 +220 1 17.8887 1.09435 4.8754 -0.773263 0.600717 5.02725 +221 2 18.623 1.41887 4.35928 5.70444 0.114988 -11.5441 +222 2 17.8389 1.7231 5.59879 -7.43418 -0.321368 4.00301 +223 1 6.81825 9.41317 4.48156 7.11204 -1.13267 15.9283 +224 2 6.84118 9.52277 5.44603 -5.88151 0.934362 -6.29355 +225 2 7.74851 9.26985 4.27279 -2.06614 -3.64671 -7.13223 +226 1 2.66566 14.925 1.97184 3.43761 -5.8072 22.4208 +227 2 3.31024 14.6851 2.65976 -11.6222 2.95672 -3.26291 +228 2 3.19272 14.9753 1.1906 5.92571 0.162325 -19.2981 +229 1 17.2917 12.9099 13.1468 13.6904 -32.8575 1.82925 +230 2 16.4305 13.254 13.3667 -5.78742 18.0954 -2.54799 +231 2 17.8833 13.5932 12.8229 -8.84805 15.1913 2.15275 +232 1 14.9839 10.5629 1.38454 25.7264 11.2091 10.263 +233 2 15.6084 11.2587 1.71974 -19.4135 -18.6888 -7.72567 +234 2 14.1549 11.0026 1.25075 -10.8149 6.915 -1.22185 +235 1 5.70372 6.84607 4.55662 8.80438 8.80025 -0.823305 +236 2 6.10735 7.7373 4.58073 -7.50282 -10.5851 -1.04914 +237 2 6.32636 6.24858 4.99 1.7616 -0.154003 4.43374 +238 1 8.04871 8.29405 10.2754 3.94684 3.34606 -22.4081 +239 2 8.71637 8.94856 10.0317 -1.03323 4.34225 9.84614 +240 2 7.78699 7.97842 9.39774 -4.16124 -6.72066 12.7971 +241 1 13.4913 18.3469 5.77892 -1.26098 13.9384 -13.7404 +242 2 12.815 0.368504 5.57583 1.14564 -3.93427 -2.76608 +243 2 13.0908 17.8361 6.47463 -1.65231 -11.4802 12.6171 +244 1 0.227007 2.59645 0.141675 -14.0496 12.7254 8.33212 +245 2 17.9751 2.93781 18.665 -4.73692 -13.8452 -6.2234 +246 2 0.694599 3.38298 0.431909 14.3746 0.669884 0.426623 +247 1 12.7219 11.0238 9.75183 49.8657 -12.692 14.413 +248 2 11.8223 11.0616 9.49871 -31.5247 -8.5727 -6.88909 +249 2 12.9406 10.0926 10.0008 -12.7634 16.4478 -4.29644 +250 1 0.765495 12.2256 11.092 -6.27201 -3.92882 -21.6672 +251 2 18.4439 12.3344 11.0429 5.26844 -2.50397 8.5312 +252 2 1.08097 12.384 11.9788 -3.27397 5.59862 9.72518 +253 1 5.06534 7.27352 13.4491 9.82463 3.8805 6.07585 +254 2 5.60445 7.97165 13.048 -4.44492 -2.76176 -4.56894 +255 2 5.50693 7.14172 14.2991 -3.01503 -3.24863 -0.495805 +256 1 1.24722 6.90803 11.85 29.2977 26.916 27.8288 +257 2 0.522094 7.24638 11.3513 -16.2758 4.78156 -11.2742 +258 2 1.67283 7.72942 12.2344 -11.891 -29.9717 -16.3043 +259 1 15.4903 9.51892 12.3126 7.40517 -6.095 -16.4028 +260 2 15.1231 10.4002 12.2744 -2.67202 9.46709 6.64342 +261 2 15.3464 9.12903 13.1709 -3.09066 3.82816 8.99587 +262 1 16.6298 12.8631 5.48891 1.11523 -3.92575 5.75418 +263 2 16.4995 13.8048 5.46845 -2.55881 16.2829 11.3267 +264 2 16.4805 12.6501 4.57692 -1.87933 -15.1854 -15.6508 +265 1 6.21094 9.97472 0.0957231 23.6487 -5.34392 2.82943 +266 2 5.60453 10.4038 0.703481 -3.26342 3.61778 2.3496 +267 2 7.09538 10.0231 0.521798 -18.1891 -1.30215 -0.820391 +268 1 12.348 6.08762 4.05307 2.0614 24.7942 -10.4953 +269 2 12.1492 6.85087 3.46448 11.8353 -14.4305 6.54315 +270 2 11.534 5.60454 4.05688 -13.4451 -11.2489 2.03158 +271 1 0.182227 12.8112 0.197519 7.97213 -0.157956 2.72486 +272 2 0.124577 13.5143 0.856815 -1.71897 -0.134619 0.137441 +273 2 18.3975 13.1734 18.0617 -3.09196 -0.84285 -5.0356 +274 1 3.77998 18.5905 8.57799 -18.8802 5.92516 7.26956 +275 2 3.52251 17.9827 7.88131 5.13558 -0.560148 -6.56591 +276 2 2.92387 0.359522 8.79319 10.0752 -0.462424 4.43469 +277 1 7.44275 17.2901 4.46744 -21.5086 -34.4409 7.51913 +278 2 7.83961 18.0981 4.73248 10.1677 27.4444 -0.194329 +279 2 7.33826 17.2675 3.51576 6.23588 9.30645 -6.08156 +280 1 9.24103 17.0711 12.2479 -19.3743 11.7076 -0.715804 +281 2 9.17102 16.3949 11.5719 7.91635 -8.00505 -0.934966 +282 2 10.0835 16.9964 12.6894 10.2718 -1.4174 0.528472 +283 1 13.295 12.9281 7.96455 10.8524 35.2373 8.53109 +284 2 13.4175 12.2933 8.66577 -5.31299 -13.0614 2.94334 +285 2 13.7676 13.7325 8.27776 -0.249345 -13.5851 -11.5496 +286 1 14.9473 2.96516 15.3472 -8.56764 -6.90335 7.41648 +287 2 14.4704 2.13858 15.1989 -5.86972 7.46703 2.11397 +288 2 15.5773 2.99488 14.6333 9.67131 3.29159 -8.66831 +289 1 9.8733 15.5399 16.9999 -1.15808 -3.26391 2.43146 +290 2 10.4067 14.7753 16.7398 -3.17357 -1.97936 0.56939 +291 2 9.29049 15.2638 17.7267 6.50431 4.19029 -1.43758 +292 1 11.3155 8.30103 16.5489 -8.97523 -12.184 6.64215 +293 2 10.5995 7.86385 16.0596 7.08532 7.34183 -0.412451 +294 2 11.4953 7.67267 17.2664 2.19784 9.25982 -2.90547 +295 1 3.86136 18.202 16.7472 -0.00540616 -19.6914 -20.2162 +296 2 4.27115 17.4628 17.2262 -1.12743 11.6131 4.05136 +297 2 3.85436 0.333712 17.2887 2.36829 10.2975 15.3313 +298 1 2.18996 4.14488 8.93819 0.886129 3.08448 -7.12661 +299 2 3.10445 4.02058 8.72725 13.9566 -1.85365 -12.2229 +300 2 2.19804 3.9794 9.87086 -10.6985 1.40109 20.9797 +301 1 9.87077 10.3617 9.71962 10.1113 -1.13074 11.4426 +302 2 9.57245 11.1887 9.34333 -7.01747 6.00246 -6.1834 +303 2 10.1269 10.5679 10.6319 -2.96085 -6.85282 -1.29137 +304 1 9.72151 0.827202 10.8565 -16.8019 0.79505 -1.6906 +305 2 9.17924 18.7332 11.1654 13.4836 -3.87865 6.80866 +306 2 9.14124 1.21724 10.1941 6.30814 7.82285 -3.72399 +307 1 9.21217 15.15 10.2242 6.46373 1.33184 2.55262 +308 2 8.76537 15.794 9.67699 -2.80645 8.81337 -5.09524 +309 2 8.53339 14.5081 10.4276 -6.91387 -6.36492 -2.48134 +310 1 0.979873 9.39617 10.3168 -32.1534 32.2854 2.26584 +311 2 1.01417 10.3672 10.3328 -11.1793 -7.1298 6.70775 +312 2 1.8685 9.20872 10.1515 40.6499 -19.8378 -9.87175 +313 1 16.9127 4.85919 8.18774 -4.59801 12.0977 -12.3954 +314 2 16.2737 5.53573 8.4435 0.928859 1.2732 2.05393 +315 2 16.9639 4.27263 8.93179 4.52425 -11.0836 8.47724 +316 1 14.6737 14.709 0.318185 15.3338 2.15239 -13.9805 +317 2 15.2295 14.9726 1.0606 -1.701 5.56475 -1.20644 +318 2 13.8551 14.4222 0.702232 -12.5496 -7.63291 5.74768 +319 1 3.57822 11.0521 9.58832 7.05767 -0.848593 3.86503 +320 2 3.70772 11.5491 10.4084 -2.82358 -5.49605 1.13538 +321 2 3.0796 11.6369 9.01245 -0.492053 5.16034 -4.32733 +322 1 11.1043 10.8166 1.33994 -11.5702 -13.9866 8.70354 +323 2 11.3928 11.6085 0.903197 7.06397 14.5046 -5.44138 +324 2 10.1649 10.7312 1.10986 7.36828 -2.13735 3.91294 +325 1 13.1846 7.09882 12.8318 18.6724 6.28095 -0.937746 +326 2 14.1536 6.98642 12.9472 -16.4658 1.64828 -3.93553 +327 2 12.8311 6.20921 12.7949 -4.05904 -6.33012 1.01947 +328 1 9.62724 1.89857 0.976269 -5.84048 -4.71512 -19.854 +329 2 8.85605 1.47112 0.556627 5.981 10.7585 7.84687 +330 2 10.1714 2.22507 0.238723 -1.51496 -2.73206 9.47681 +331 1 10.5937 13.5214 4.66199 3.2234 0.0339744 -7.62843 +332 2 11.4486 13.114 4.51461 3.39436 -8.72009 -0.849353 +333 2 10.7191 13.8974 5.52846 -5.55452 9.94363 9.85641 +334 1 14.3279 1.73837 10.9221 -6.80645 -20.6925 1.76137 +335 2 15.1234 1.41881 10.4767 1.97621 6.90305 1.731 +336 2 14.3743 2.69243 10.9875 9.24527 6.91542 -4.56959 +337 1 14.6348 12.3447 11.7069 0.143663 -8.85162 -7.69369 +338 2 15.3924 12.4169 11.1267 15.8185 6.23005 6.53749 +339 2 13.9779 12.0599 11.0796 -19.2308 -4.32411 1.56042 +340 1 8.24345 5.06862 9.81236 -2.43519 -19.796 -15.4196 +341 2 7.42328 5.28077 10.2334 -12.2119 11.2175 13.6651 +342 2 8.03366 4.19231 9.43495 14.0834 8.03075 2.78805 +343 1 1.55958 16.8456 18.3509 0.293915 -24.903 24.1992 +344 2 1.74487 17.2231 17.5072 8.4457 6.47265 -18.7434 +345 2 1.95964 15.9468 18.3277 -12.6492 15.8955 -3.16542 +346 1 1.46885 17.2295 15.3261 -41.9231 18.9429 7.61422 +347 2 1.60163 18.0716 15.7975 2.88525 -7.29411 -7.90761 +348 2 0.471438 17.1304 15.2829 39.2238 -5.53287 -0.382895 +349 1 3.69895 5.65007 6.13962 5.67498 -13.7905 -4.71311 +350 2 3.08621 6.15365 6.67268 -1.79156 10.6243 5.04455 +351 2 4.29662 6.26435 5.6935 -4.62364 1.91275 -0.121461 +352 1 12.3686 9.4572 14.1916 2.50325 4.1373 0.835901 +353 2 12.6534 8.64397 13.7789 7.43403 -8.19142 -7.10693 +354 2 12.2431 9.18714 15.1032 -3.68368 1.41273 6.14038 +355 1 4.03462 15.2828 6.91278 -20.0144 -6.90546 3.84648 +356 2 3.57361 16.022 6.48562 4.0204 -1.30953 4.99773 +357 2 4.97214 15.427 6.85986 17.0804 8.85667 -5.89205 +358 1 0.596937 8.57007 14.913 -2.82207 -2.34568 11.0967 +359 2 0.589839 9.51288 15.1099 0.171131 2.88226 -3.41975 +360 2 1.22453 8.45469 14.2015 6.96836 3.95738 -3.73783 +361 1 12.9772 8.31295 10.3135 -4.52981 3.4147 9.81026 +362 2 13.748 7.88649 9.95158 7.10588 -4.96512 -13.4998 +363 2 13.0418 8.05063 11.2408 -7.87478 3.04011 -0.538852 +364 1 15.3081 7.67138 3.5266 23.4653 37.2808 -10.5735 +365 2 14.5495 7.31548 3.08478 -13.5361 -20.5278 3.76808 +366 2 15.7097 7.21489 4.26906 -13.5998 -13.5183 6.32814 +367 1 17.3139 6.67347 0.0519528 8.75828 -11.5188 0.32751 +368 2 16.922 5.81479 0.236083 -1.36263 0.235584 3.31968 +369 2 16.5542 7.20912 18.4844 -8.7655 12.4237 -8.09845 +370 1 8.86065 6.91878 7.81669 10.1209 17.2302 -14.0365 +371 2 9.80786 7.17641 7.77744 -16.0922 -4.42618 4.57681 +372 2 8.74795 6.24147 8.48473 3.77983 -6.9476 8.96536 +373 1 12.3541 0.627989 1.20673 7.59332 -4.64776 2.86492 +374 2 13.2579 0.528374 1.53727 -3.51801 6.0046 2.76074 +375 2 12.2851 18.632 0.498856 -2.53947 0.382583 -4.14536 +376 1 5.64549 15.138 14.5235 -4.10456 -30.421 5.78959 +377 2 4.73353 15.1769 14.8501 2.72532 6.49481 -6.12593 +378 2 5.9656 16.0086 14.3294 1.76375 18.5631 -6.42604 +379 1 3.85619 6.49135 1.72458 1.34418 -5.76632 6.1851 +380 2 3.4082 7.28863 1.44351 -4.61345 8.91678 -8.73454 +381 2 4.04036 6.67595 2.65567 -1.04596 -4.79787 -3.17499 +382 1 3.88128 11.6181 12.3021 -8.90147 -4.54474 -0.675722 +383 2 4.76839 11.88 12.5585 3.1774 6.51538 0.922611 +384 2 3.25574 12.2257 12.7332 9.80963 -6.2977 -1.14662 +385 1 5.41097 3.86243 15.8619 7.77498 -26.7447 2.47729 +386 2 6.19051 3.2555 15.8125 -22.34 13.8462 -4.82428 +387 2 5.75732 4.74289 15.8731 9.06733 16.771 0.375084 +388 1 14.4275 10.3077 4.42737 -15.4583 -1.2468 24.8449 +389 2 14.4136 9.7945 5.25584 5.65105 6.60384 -6.24763 +390 2 14.7139 9.69599 3.76155 7.16087 -8.52398 -12.4829 +391 1 7.87022 17.3652 9.18307 -6.55512 0.129027 -0.760847 +392 2 7.04604 17.5698 9.62158 -5.94597 -4.85201 9.5143 +393 2 7.92762 18.0395 8.50377 8.60962 -1.46955 -8.60251 +394 1 4.50919 14.4633 3.94747 -3.26277 6.69504 -13.1744 +395 2 4.44326 15.3745 4.23469 1.61374 7.68172 -2.63862 +396 2 4.73121 13.9745 4.72809 3.38773 -13.7326 11.5154 +397 1 14.2916 7.39166 15.7799 -19.0102 -0.643935 -4.97281 +398 2 15.227 7.28492 15.6956 21.3172 -2.59108 -3.06 +399 2 14.1661 7.73476 16.6606 0.966931 5.43289 9.36717 +400 1 2.93597 18.2496 1.90178 2.72474 -19.4407 -7.90163 +401 2 2.41137 17.5137 1.50762 13.3283 19.165 4.04527 +402 2 2.31568 18.912 2.18531 -12.4791 7.28301 8.56329 +403 1 7.97625 1.60842 4.55987 -20.0747 11.2227 -5.58284 +404 2 7.40672 2.18903 4.02942 -3.00667 -10.939 3.58357 +405 2 8.83426 1.86357 4.26417 23.6954 -1.42515 0.234182 +406 1 2.55973 14.139 17.7235 4.4947 4.4122 -3.81652 +407 2 1.9869 13.4419 18.0532 -4.8721 0.171095 2.94118 +408 2 3.45785 13.8729 17.9629 -0.333069 -3.9381 0.822902 +409 1 0.778432 1.72633 13.8806 -27.0748 -1.51039 10.7449 +410 2 0.840363 1.33642 14.7677 3.59517 6.80992 -7.55552 +411 2 18.4512 1.86919 13.7675 25.1129 -0.50251 -4.23703 +412 1 4.5218 18.6217 13.9311 -26.2208 4.76485 6.31935 +413 2 5.44026 18.4597 14.0857 18.6112 -6.32709 -3.49173 +414 2 4.08533 18.4032 14.7706 3.39103 3.57256 -5.13956 +415 1 7.0966 0.590139 18.3583 40.0867 -7.03194 -16.485 +416 2 7.43029 0.218977 17.5038 -14.1267 7.45313 19.238 +417 2 6.15491 0.497007 18.3797 -17.6926 4.43938 -0.268226 +418 1 16.0869 18.4184 14.0665 12.1783 12.0602 19.9903 +419 2 15.2602 18.093 13.7757 -22.8702 -12.1677 -15.3509 +420 2 15.9307 18.6351 14.9998 9.22594 -1.26981 -3.76068 +421 1 10.0615 4.5254 16.2644 17.4965 34.4304 -0.599412 +422 2 10.952 4.96419 16.2693 -15.2122 -21.3498 0.578373 +423 2 10.2001 3.58581 16.3272 5.99955 -12.591 -1.94777 +424 1 15.8874 17.8488 4.44366 26.9944 -8.8935 -8.85545 +425 2 16.3583 18.6921 4.41154 0.375294 -2.3726 2.41747 +426 2 14.9936 18.0388 4.65191 -27.7242 10.9512 11.1951 +427 1 6.97313 17.3837 13.7492 -14.8371 0.980348 6.17816 +428 2 7.33935 17.5289 14.6184 6.46616 5.40365 9.01508 +429 2 7.73032 17.2786 13.1826 8.79779 -2.98362 -9.94394 +430 1 13.295 6.50203 6.69495 9.53809 17.2257 -14.0038 +431 2 14.0496 7.07319 6.46986 -0.499105 -8.31015 13.7378 +432 2 12.8724 6.42857 5.83749 -8.85952 -9.05901 -3.70628 +433 1 7.73318 2.36184 9.23357 -5.82839 -0.191385 25.6357 +434 2 7.13515 2.2598 10.0003 13.8878 3.27143 -3.38814 +435 2 7.19146 2.08044 8.50905 -8.01798 -3.82737 -18.8349 +436 1 15.1683 14.8678 13.6621 4.32457 -5.24538 6.92634 +437 2 15.0117 15.191 14.5524 1.96766 -1.10504 5.54809 +438 2 14.4461 15.1877 13.1369 -6.78809 4.58671 -11.3713 +439 1 9.33811 8.31525 3.72912 -3.71623 14.6513 -1.76526 +440 2 10.1422 8.72537 4.07444 1.32163 -4.04075 -0.39549 +441 2 9.3744 7.3721 3.88081 4.66337 -7.69389 3.46587 +442 1 17.73 13.5264 16.4473 3.62887 -10.5665 6.33517 +443 2 16.8053 13.2497 16.375 1.67263 6.91521 -3.1024 +444 2 17.8249 14.3621 15.9879 -5.28625 7.64018 -4.86126 +445 1 4.99014 10.6392 2.69296 -11.8842 10.0017 7.67541 +446 2 5.62836 10.2105 3.25699 12.1385 -6.17254 3.53336 +447 2 4.64978 11.3543 3.2597 0.304061 -9.29163 -9.90123 +448 1 3.7356 8.34279 10.2382 -0.81373 18.9096 -12.0232 +449 2 3.86658 9.26506 9.94102 0.197912 -10.4595 0.115104 +450 2 3.49052 8.44407 11.1547 0.601112 -5.92985 11.4704 +451 1 16.0428 7.05286 6.2029 -10.6575 13.2953 -5.82849 +452 2 16.855 7.48535 6.46978 4.82485 2.35526 4.73173 +453 2 16.1613 6.12013 6.32007 7.39497 -13.7867 -3.51418 +454 1 15.1327 7.05037 9.11575 3.87713 -5.32828 6.40762 +455 2 15.8626 7.43029 9.61535 2.26476 1.25298 1.00848 +456 2 15.1324 7.53151 8.29313 -1.46271 6.60183 -11.5025 +457 1 6.39444 13.0666 12.8402 5.00849 -18.9174 -4.31708 +458 2 7.14138 12.6166 13.2588 -1.3728 0.0732389 -8.28768 +459 2 6.25233 13.8543 13.3456 -7.70591 16.466 12.3405 +460 1 12.1285 4.48598 13.0882 -38.1563 -9.245 -8.92104 +461 2 12.05 4.67155 14.023 12.2106 4.08095 10.8898 +462 2 11.2367 4.10453 12.8753 29.4794 5.44987 -0.890783 +463 1 11.348 8.18475 7.8598 -17.4059 7.12531 -10.6431 +464 2 12.038 7.63484 7.48501 10.4081 -6.60064 5.31237 +465 2 11.4756 8.28116 8.80352 11.9689 -3.04214 7.26146 +466 1 17.1922 10.8074 7.44155 -25.4203 14.6985 18.6261 +467 2 17.9197 10.2075 7.32737 10.9985 -8.38668 -11.5183 +468 2 17.0629 11.3797 6.67504 9.09121 -1.65978 -2.87918 +469 1 5.25169 18.1248 11.0507 12.0648 3.50666 -3.83562 +470 2 4.62743 17.897 11.7414 -1.9785 0.423337 4.7613 +471 2 4.73712 18.33 10.2687 -7.94827 -3.02158 -5.48025 +472 1 7.57794 17.5568 1.83513 6.93874 5.3114 -35.8297 +473 2 7.86736 16.7596 1.34843 -3.99011 9.3379 11.9664 +474 2 7.57256 18.2518 1.1344 -7.92946 -12.1924 16.8763 +475 1 1.91036 12.9101 13.6013 -3.96045 -14.8375 -19.2024 +476 2 1.39392 12.2568 14.0828 0.939403 1.79227 7.54842 +477 2 2.06766 13.6568 14.1634 3.48639 14.3121 10.7878 +478 1 9.68075 6.78169 14.8149 2.18853 -17.0585 -1.56943 +479 2 9.86519 5.84438 15.0146 -5.66436 10.7434 4.7021 +480 2 10.1054 6.93436 13.9655 -4.91522 4.89205 -3.51643 +481 1 15.2489 4.31705 10.7696 10.3165 19.1063 17.7081 +482 2 16.2033 4.28261 10.8841 1.13215 -16.3849 -6.84609 +483 2 15.045 4.99149 11.4324 -10.9146 -3.35461 -8.40134 +484 1 11.2157 6.13912 0.184288 19.0347 18.6277 4.4365 +485 2 11.389 5.28379 -0.213728 -9.30505 -7.86745 -0.661886 +486 2 10.2971 6.41228 18.7766 -10.0409 -9.92482 -6.17869 +487 1 0.119384 11.3453 15.1007 -14.3711 11.1071 -8.9459 +488 2 18.1083 11.5338 14.3994 8.87914 -3.31428 2.86805 +489 2 18.675 12.1405 15.6491 -0.376992 -6.76779 4.41889 +490 1 7.06293 9.20482 7.26347 16.9728 2.93661 -2.33726 +491 2 6.45996 8.52415 7.5376 -12.746 -11.932 7.1182 +492 2 7.92776 8.76781 7.32981 -4.82181 7.51802 -3.03552 +493 1 18.3776 15.4097 12.3582 -11.3114 -7.16639 4.00893 +494 2 0.682756 15.4096 12.2525 13.0982 4.14044 -6.05458 +495 2 17.9899 15.7976 11.566 2.11158 0.973908 -1.02825 +496 1 16.5513 4.36706 5.24159 -5.09045 5.24791 -23.7034 +497 2 16.6166 4.33687 6.19466 14.1446 -5.59224 10.5876 +498 2 17.404 4.59908 4.81371 -8.86364 -4.80736 14.9956 +499 1 17.7417 3.09647 10.7341 0.291254 -10.6186 -10.4582 +500 2 0.00513181 3.34109 10.9087 8.18655 7.52385 6.55564 +501 2 17.8253 2.23203 10.2933 -8.67083 8.1401 4.47273 +502 1 12.2919 0.0227122 10.1361 2.29147 -28.3523 -7.04943 +503 2 11.4789 0.3695 10.4906 -11.5623 8.87459 2.77288 +504 2 12.9485 0.705533 10.1424 9.22066 20.6222 4.35768 +505 1 10.3653 9.79669 12.372 -8.95345 -3.20907 -9.5203 +506 2 11.0695 9.83133 13.0162 9.21286 -1.60231 7.36796 +507 2 10.2442 8.85709 12.1552 0.446892 6.98856 4.38647 +508 1 0.537603 2.83987 7.02256 -3.09155 -21.8169 -17.6677 +509 2 0.689112 3.48917 7.69969 6.81735 5.32415 12.4887 +510 2 0.745143 1.97019 7.39814 0.967775 11.9311 3.78775 +511 1 0.407687 15.2844 6.91114 -10.1505 12.0239 22.1786 +512 2 0.487576 14.9005 7.81264 0.770838 8.15944 -16.8401 +513 2 0.754028 14.6482 6.29753 4.41733 -17.9374 -4.37366 +514 1 17.0108 7.01877 15.2726 9.75856 -4.98107 -8.16179 +515 2 17.7945 7.53845 15.0774 -4.62906 13.8031 -0.900924 +516 2 17.4019 6.14594 15.3485 -8.43732 -9.20439 7.91006 +517 1 9.04118 12.4266 8.12126 20.8625 -13.8276 -21.4288 +518 2 9.31201 11.8186 7.41014 14.8696 5.22508 9.07579 +519 2 8.11227 12.3461 8.03152 -32.7632 10.2849 9.08461 +520 1 1.26557 1.8876 3.02782 9.65045 8.01813 1.36118 +521 2 0.751817 2.27104 2.32199 -7.08934 -1.28284 -8.05339 +522 2 1.78864 2.63408 3.35807 -1.4257 -10.3882 4.86199 +523 1 4.12138 15.1091 9.73113 11.5132 -2.98862 0.0844269 +524 2 4.08037 15.3711 8.80771 -6.64563 1.38763 -1.25331 +525 2 5.02377 14.7713 9.82789 -5.61093 0.302526 6.22582 +526 1 7.21558 2.18454 14.596 -3.30246 -13.7461 5.2135 +527 2 6.95017 1.78255 13.7582 4.82488 2.3919 4.06302 +528 2 7.77929 2.92256 14.3836 3.82883 9.51482 -6.38734 +529 1 18.5827 14.6796 2.1698 -24.3208 -2.36026 -2.50397 +530 2 0.827663 15.0286 2.10654 6.16868 9.29818 1.18622 +531 2 17.9285 15.4101 2.10387 15.0339 -9.50868 3.05979 +532 1 9.96457 2.76705 12.9307 -6.0306 9.60441 -0.715471 +533 2 9.81933 2.16697 12.1996 2.81266 -10.505 -5.71659 +534 2 9.23975 3.40361 12.8511 1.73763 -0.77134 6.44595 +535 1 2.86173 8.92609 13.0404 7.24036 -2.57601 -2.21085 +536 2 3.32754 9.76259 12.8684 -5.41233 -1.95407 1.34833 +537 2 3.53569 8.30272 13.3558 -0.616664 3.71534 -0.977901 +538 1 3.21505 8.40688 3.66968 15.7234 22.1036 -19.602 +539 2 3.76887 9.07341 3.20135 -16.7118 -11.852 2.14794 +540 2 3.39007 8.60458 4.57891 -0.363765 -1.98929 20.9454 +541 1 5.60252 7.19004 8.53175 5.86958 -4.86959 9.5617 +542 2 5.84506 6.27445 8.70563 -2.01066 -2.63063 -12.6146 +543 2 5.1548 7.42343 9.34691 -7.32508 9.6882 0.185442 +544 1 14.8904 1.34267 1.9851 -2.44355 -11.2972 17.4528 +545 2 14.6303 2.11535 2.51846 2.91157 0.487188 -15.3266 +546 2 15.025 1.53806 1.05778 2.17575 14.4946 -4.76666 +547 1 8.30348 15.1948 0.839181 1.62975 3.11742 -15.2912 +548 2 9.05101 15.1086 1.44328 -1.42893 -5.28711 5.64984 +549 2 7.54504 14.6965 1.17349 5.50357 -4.17517 7.24781 +550 1 15.6062 1.34647 7.22998 12.9139 6.24135 5.03718 +551 2 15.0343 0.764422 6.7383 -10.7397 -5.17 -5.22658 +552 2 15.1371 2.18077 7.35367 -5.42005 -2.19365 2.65732 +553 1 4.96367 13.0608 18.5175 -8.25637 -3.65043 -17.7207 +554 2 5.34878 13.2483 0.722802 8.16177 0.261597 12.4464 +555 2 5.65153 13.2431 17.8644 -2.22894 4.298 3.81358 +556 1 15.3614 8.50445 18.1376 -9.02232 -8.38547 12.9254 +557 2 15.7319 9.00583 17.4156 5.20151 10.9324 -8.24127 +558 2 15.1687 9.14311 0.198883 4.58141 -1.82544 -4.44514 +559 1 12.0904 3.05083 18.3558 5.74067 -18.2993 3.78166 +560 2 12.2947 2.48128 0.458355 -7.48955 9.04159 13.408 +561 2 12.4465 2.47277 17.6781 -3.43414 10.0689 -17.6065 +562 1 13.2065 12.6801 5.18634 5.84251 -1.21193 6.01102 +563 2 13.6832 11.8727 4.98831 0.374712 -2.89081 -11.6293 +564 2 13.5252 12.8732 6.07674 -9.12379 3.52213 -1.02632 +565 1 6.05538 7.10808 0.0622478 7.64822 4.54905 2.96407 +566 2 5.99209 8.01824 19.0386 -2.92171 -4.08442 -8.95141 +567 2 5.21644 6.68693 0.272307 -1.20959 2.69213 5.93171 +568 1 17.7218 15.9656 14.99 27.5308 -15.6865 18.0891 +569 2 16.9388 16.4863 15.1181 -14.3434 5.91292 -14.0866 +570 2 17.911 15.7342 14.0701 -14.8265 10.2647 -3.26624 +571 1 13.1712 0.994875 16.5867 2.52549 -1.56274 -3.32645 +572 2 14.0875 0.750433 16.7652 2.07951 0.899412 2.60052 +573 2 12.7522 0.177983 16.2988 -0.931869 -3.47373 4.92885 +574 1 11.0723 14.6005 7.26575 -13.1255 -10.0571 4.65979 +575 2 10.3507 14.0428 7.62559 10.576 8.81418 -2.61622 +576 2 11.902 14.168 7.50495 -4.44994 -4.81764 -1.49609 +577 1 17.5239 8.59779 2.09084 -4.28833 -20.5194 -15.9758 +578 2 16.6824 8.33187 2.48237 1.37862 7.81735 4.46419 +579 2 17.5834 7.99355 1.32242 5.93631 9.11716 13.4418 +580 1 12.3581 7.93946 1.97566 -1.89696 -6.27914 -3.50436 +581 2 11.9505 8.79823 2.04436 -0.86405 10.6038 1.69948 +582 2 11.9097 7.53044 1.22383 5.98844 -6.29912 5.7943 +583 1 11.9176 14.6241 10.3724 -2.87076 17.8373 18.3305 +584 2 12.1889 13.9308 9.80998 14.0474 -22.5763 -16.4958 +585 2 11.017 14.792 10.1004 -10.4734 4.60408 5.02203 +586 1 6.86179 7.0045 15.5825 0.298402 -7.5032 -11.9192 +587 2 7.72978 7.09161 15.1865 4.58892 -5.83629 -5.839 +588 2 6.8806 7.68521 16.2363 -7.39186 11.3873 16.6815 +589 1 8.0061 4.66768 13.4643 -26.1906 -20.4665 -29.1007 +590 2 7.40104 4.82554 12.6933 13.2028 -5.13213 23.0799 +591 2 8.47723 5.469 13.5831 13.4856 24.6751 2.60837 +592 1 13.392 12.1682 14.29 6.21681 3.24263 -1.56593 +593 2 13.3744 11.2127 14.1772 -7.69192 -2.80185 3.02585 +594 2 13.9051 12.489 13.5384 -1.40129 2.2659 -1.62493 +595 1 14.7806 9.45441 7.28093 -11.5532 20.7697 15.955 +596 2 15.4984 10.0862 7.4818 -3.61589 -14.7511 -6.73617 +597 2 14.0294 9.75726 7.82532 9.94729 -6.45384 -10.5104 +598 1 12.6903 16.9959 3.11063 13.9021 -20.0527 -1.11079 +599 2 13.0479 17.2495 3.95961 -1.86196 6.25123 9.18833 +600 2 12.0243 17.6278 2.88206 -13.6174 14.7021 -2.85583 +601 1 1.14933 7.13689 17.4392 -10.8552 -5.82346 1.42608 +602 2 0.254324 6.85235 17.6903 1.68989 10.0465 1.1249 +603 2 1.04814 7.64429 16.6282 0.816381 -0.80389 -4.56811 +604 1 12.8311 5.11146 15.6849 -17.6595 -4.33947 -1.38663 +605 2 13.5036 4.46543 15.459 7.94947 -3.95791 3.77703 +606 2 13.2565 5.97185 15.6774 7.16 2.75079 -1.64654 +607 1 2.47852 3.39671 5.05511 -15.8601 -20.9034 -7.20071 +608 2 1.89248 3.0773 5.76599 4.829 7.89548 -3.4806 +609 2 3.06433 4.04634 5.42706 4.34046 14.9349 7.02505 +610 1 8.31182 11.2281 13.4853 12.2486 -8.92827 -7.03776 +611 2 8.34382 10.988 14.3869 -16.2376 0.866389 37.005 +612 2 9.12412 10.7865 13.2309 -0.249665 2.67206 -26.3927 +613 1 12.9087 1.417 13.3166 0.0274524 -25.355 19.3096 +614 2 13.4801 1.21198 12.5759 3.32243 8.60198 -10.444 +615 2 12.4274 2.20637 13.1188 -4.80778 18.3372 -7.59901 +616 1 6.3961 13.6531 2.14242 21.3539 -7.72513 -19.5528 +617 2 5.86296 14.1246 2.76583 -10.9825 4.85946 19.6126 +618 2 7.0399 13.1177 2.63436 -6.77103 3.35988 1.82582 +619 1 15.9312 6.57282 12.7577 9.39393 9.94387 -6.4398 +620 2 16.4454 7.11896 12.1297 -10.141 -7.43973 7.84454 +621 2 16.2972 6.7745 13.6327 -0.398164 -4.05689 -3.4507 +622 1 16.8338 0.714138 9.59622 -4.58014 7.56344 -3.36861 +623 2 16.786 18.4184 9.78234 2.45796 -8.84878 0.088887 +624 2 16.3762 0.83732 8.75167 2.21028 0.792186 -0.559114 +625 1 6.14371 11.7069 8.36929 2.81279 3.26044 -4.5559 +626 2 5.21452 11.6136 8.62066 2.93526 -5.28935 1.80511 +627 2 6.46143 10.8412 8.07651 -3.38714 0.356066 2.25694 +628 1 2.85881 8.67012 0.388915 2.79689 11.0982 14.7719 +629 2 2.20875 8.30366 18.4701 -9.93413 -28.5632 -26.9968 +630 2 2.30006 9.32334 0.801848 8.26615 13.7996 15.8107 +631 1 10.1321 10.4555 6.53489 -7.45039 0.329373 10.0784 +632 2 10.6046 9.83719 7.10845 -0.190248 -0.487921 -4.0191 +633 2 10.6634 10.5725 5.74842 5.176 -1.34798 -7.09506 +634 1 6.75471 15.7115 6.57125 -11.9312 -6.35937 -2.57899 +635 2 7.17812 16.0056 7.37746 4.55156 8.98271 2.0062 +636 2 6.84858 16.4009 5.89838 10.4548 -3.40393 4.92981 +637 1 6.44667 13.1112 5.62964 2.65073 6.32881 3.74437 +638 2 6.67596 13.9769 6.00675 -0.0120675 -6.80172 -3.34498 +639 2 5.96115 12.6448 6.31389 0.45756 -2.92263 2.45964 +640 1 16.7937 12.5442 9.80018 5.98989 11.7335 -8.95445 +641 2 16.9887 11.9765 9.05284 -0.702856 -11.4944 -2.64553 +642 2 17.0098 13.4184 9.45025 -4.64512 -2.35242 9.41775 +643 1 6.08081 2.94855 2.81201 5.81343 6.87552 13.2918 +644 2 6.21399 3.88965 2.59312 -1.02666 -12.0092 -4.68113 +645 2 5.77459 2.45978 2.03916 -1.91968 5.61369 -5.09877 +646 1 10.8797 3.26448 3.27711 -5.41025 -2.45564 -6.20574 +647 2 10.301 3.99846 3.49319 -0.0844139 2.78359 4.78679 +648 2 10.5123 2.93026 2.45079 3.61554 -5.12824 0.569032 +ITEM: TIMESTEP +40 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.73557 7.01799 17.9607 21.964 -6.69295 -3.41675 +2 2 7.837 6.97936 18.244 -22.923 1.28376 8.03757 +3 2 8.84363 6.25859 17.3828 1.27689 0.0651665 -4.69765 +4 1 18.6647 8.30209 6.83035 -0.644058 3.99523 -48.5507 +5 2 0.211245 8.12789 5.86514 -9.60619 8.91963 25.083 +6 2 0.465598 7.58914 7.26037 9.90688 -14.2806 22.1152 +7 1 8.44495 18.6364 6.8238 -19.0399 -0.344231 6.51496 +8 2 9.34052 0.200584 6.61788 21.6732 5.78047 -4.99449 +9 2 7.92466 0.711623 6.44684 1.16681 0.183702 -1.11302 +10 1 6.56005 1.80411 11.6838 -38.7214 4.43655 14.793 +11 2 5.75321 2.272 12.0538 30.5925 -16.6996 -9.96133 +12 2 6.22943 0.898268 11.5156 6.32845 11.0599 0.0206858 +13 1 7.08366 5.68816 2.38617 22.7225 -30.9477 -12.475 +14 2 6.58152 6.21056 2.95839 -27.8787 23.1579 37.4024 +15 2 6.84697 6.04683 1.54845 0.038941 9.08719 -25.9535 +16 1 16.22 10.2137 16.0864 41.4588 -5.13522 6.23048 +17 2 17.1921 10.3703 16.208 -28.8473 -8.8876 -9.54756 +18 2 15.8271 11.0171 16.4051 -13.971 12.6367 2.51598 +19 1 10.6448 14.9575 2.33364 6.27542 19.2207 -0.856148 +20 2 10.5562 14.6084 3.22703 2.40752 -4.54155 -3.02292 +21 2 11.1101 15.8129 2.46012 -8.85901 -18.4002 -3.84051 +22 1 17.1611 8.2532 10.553 -11.2529 -0.0170881 12.6501 +23 2 16.8393 8.94572 11.1538 -1.12797 -5.57792 -5.31501 +24 2 17.9446 8.61302 10.1436 10.8511 4.56282 -2.94704 +25 1 14.7728 15.897 16.3892 -19.7826 14.9663 0.46496 +26 2 13.8411 16.2137 16.4626 21.4068 -5.53606 -7.5515 +27 2 14.9622 15.5552 17.2653 -0.403084 -10.0705 4.87845 +28 1 12.136 13.4022 0.475357 -11.3959 -2.02194 -12.751 +29 2 11.9408 13.3873 18.1673 8.9331 -2.53085 4.8524 +30 2 11.4037 13.9022 0.849725 6.62825 2.84238 11.8203 +31 1 9.29338 5.44787 4.01163 24.6694 12.616 -29.9837 +32 2 8.80858 5.1972 4.76287 -21.098 -14.9153 34.0625 +33 2 8.63435 5.49966 3.31701 -4.42724 -1.21089 -8.36553 +34 1 1.79376 4.18976 11.6282 4.46954 -46.7602 7.51249 +35 2 1.70048 5.09501 11.8512 -4.37305 32.1952 10.6933 +36 2 2.09275 3.70286 12.4334 -4.9207 12.4729 -20.4441 +37 1 2.01732 6.80615 8.34226 1.64844 10.8358 -0.647304 +38 2 2.37448 7.3471 9.0762 -2.77819 -13.6149 -8.9692 +39 2 1.92609 5.89421 8.65385 1.80745 6.26657 1.98394 +40 1 5.38901 4.42498 7.95307 14.0474 9.0477 19.097 +41 2 5.49608 3.48465 7.79451 -4.39314 -7.26091 -3.25333 +42 2 4.79389 4.80722 7.31869 -10.598 0.276841 -18.5158 +43 1 3.29732 2.94293 17.5086 17.2208 -30.0882 -17.6092 +44 2 4.02601 3.30007 16.978 -4.8938 2.423 1.99348 +45 2 2.81217 3.66256 17.8655 -12.7512 26.7583 13.4218 +46 1 7.44366 5.31542 6.10005 -2.04578 -15.3999 -38.6663 +47 2 8.07874 5.97061 6.33436 13.5587 20.8049 21.0336 +48 2 6.95124 5.08125 6.86821 -11.582 -6.53412 22.3247 +49 1 9.78574 7.01841 12.0035 -14.224 -5.31732 -23.9819 +50 2 10.3573 6.41663 11.5027 -2.93892 5.75769 9.08141 +51 2 9.02058 7.16943 11.392 19.9248 1.87014 17.2782 +52 1 14.0222 3.60384 8.07347 21.1656 -3.6634 36.3987 +53 2 13.9951 4.24089 7.37961 -2.65045 17.7741 -13.562 +54 2 14.5465 4.02482 8.8088 -19.0215 -13.1146 -21.9867 +55 1 4.60432 17.1743 3.97092 -4.17058 -8.50894 9.4345 +56 2 5.51528 17.3741 4.10719 24.7317 1.00316 8.45766 +57 2 4.31895 17.8257 3.35422 -16.1123 9.67587 -20.1592 +58 1 16.4938 16.6102 10.1803 -22.58 10.2442 28.8776 +59 2 15.6971 16.8258 10.7464 27.0105 -10.9286 -19.8859 +60 2 16.1827 15.9878 9.51957 -5.57273 -0.00226425 -4.98818 +61 1 1.9645 4.84741 0.368078 -14.0488 -12.8308 -13.2388 +62 2 2.69854 5.15593 0.879033 14.2396 9.43314 15.7095 +63 2 1.5724 5.64147 0.000503254 -0.0595591 4.00938 -5.12573 +64 1 11.6747 13.3071 16.3147 -7.05005 22.2307 18.0491 +65 2 11.0866 12.5598 16.3919 -3.1788 -17.5748 -3.92498 +66 2 12.2584 13.1709 15.5748 2.75178 -8.36686 -13.1919 +67 1 10.131 11.038 16.8986 -21.0542 26.9507 -1.58256 +68 2 10.4848 10.1706 16.8573 15.2828 -28.4038 0.505132 +69 2 9.17797 10.924 16.7712 4.48065 0.743861 -0.190366 +70 1 11.7352 17.4666 13.4614 -1.07936 25.6776 8.56908 +71 2 12.4835 17.2209 12.9203 3.02318 -9.35187 -8.63799 +72 2 11.8077 18.4454 13.5145 -0.798306 -16.7366 -1.43427 +73 1 6.39395 9.3313 12.2301 16.0138 21.1557 17.835 +74 2 6.78657 8.92292 11.474 4.59605 -10.3711 -18.9433 +75 2 7.12055 9.89522 12.5742 -21.4515 -7.31443 1.84288 +76 1 16.2436 12.8045 2.69297 9.19112 6.28957 -1.09055 +77 2 17.1119 13.1995 2.45018 -21.0084 -1.00278 4.98407 +78 2 15.5746 13.5129 2.79044 13.212 -4.74068 -2.98151 +79 1 0.66547 12.6008 5.89246 44.3801 0.278469 12.8923 +80 2 0.944588 12.4662 4.9918 4.15776 -1.70344 -11.3497 +81 2 18.3844 12.6561 5.85431 -44.3715 7.63264 -5.03051 +82 1 5.23201 16.4301 18.4413 -23.1671 11.3407 -2.74477 +83 2 5.81563 15.7669 18.0873 14.8521 -9.88299 1.40517 +84 2 5.51268 16.7513 0.656182 8.57816 -5.72834 2.04059 +85 1 0.568352 7.66823 4.13077 -28.9792 -20.0076 22.3714 +86 2 18.6051 8.03762 3.49503 -7.9612 4.34402 -11.87 +87 2 1.4037 8.01472 3.91532 39.463 15.435 -13.2826 +88 1 3.11888 8.95318 6.49662 60.4725 2.42495 -6.82714 +89 2 3.7308 8.46704 7.08062 -7.96075 9.2896 -8.18079 +90 2 2.27986 8.68504 6.76207 -50.4171 -10.8396 15.4956 +91 1 7.30368 10.3509 16.2473 20.2996 0.0228567 -17.1566 +92 2 6.66358 10.504 15.5564 -7.99994 0.888183 -0.524161 +93 2 6.82737 10.217 17.0566 -12.2765 1.21271 14.6854 +94 1 11.12 1.01485 5.00375 -0.0102216 2.84952 14.1843 +95 2 11.0857 1.87302 4.56078 2.3673 -3.0702 -4.20032 +96 2 10.7324 0.367128 4.41621 -3.73217 -2.39612 -13.1961 +97 1 4.37027 2.7904 13.2033 3.18584 17.5115 -8.99997 +98 2 4.79356 3.08499 14.0007 6.25053 15.0735 9.59097 +99 2 4.18046 1.89747 13.4272 -8.57413 -32.1756 -2.785 +100 1 8.40183 10.1302 1.81819 -11.3119 21.1596 -20.1509 +101 2 8.22596 10.8234 2.46526 3.55036 0.443395 1.34914 +102 2 8.74004 9.40086 2.30376 11.7587 -22.7948 15.5041 +103 1 10.4641 1.71908 15.5611 14.2583 -4.22402 3.33599 +104 2 11.4066 1.52258 15.371 -17.8532 5.60176 1.9802 +105 2 10.08 2.13518 14.7824 5.57904 -1.0897 -7.54918 +106 1 2.70316 12.9014 7.80195 3.19617 10.9991 1.8073 +107 2 3.3212 13.5754 7.49282 0.460726 -0.40643 1.73206 +108 2 2.13336 12.7538 7.04495 -5.07282 -6.75217 -1.11681 +109 1 3.70861 11.6625 5.14703 20.6482 18.5599 0.117703 +110 2 3.55555 10.8287 5.56068 -6.18613 -18.2271 10.4705 +111 2 3.04771 11.7826 4.47739 -15.5561 1.61657 -8.41129 +112 1 6.75631 14.4548 16.9127 8.94674 -1.78931 -0.924301 +113 2 7.71443 14.3361 16.9267 -6.94418 4.38523 0.882829 +114 2 6.52635 14.6721 16.0018 -2.96874 0.297136 0.835917 +115 1 14.1768 14.5549 3.37546 -9.20747 -5.25648 5.53536 +116 2 13.5738 15.2994 3.18581 6.88801 -12.7747 3.05988 +117 2 13.7349 13.9262 3.9882 4.46288 16.3838 -11.0193 +118 1 8.36945 18.1316 16.043 -50.6417 14.5597 -0.377943 +119 2 8.83326 17.39 16.374 32.1095 -21.5179 4.54953 +120 2 8.87194 0.178112 15.6264 24.4627 6.71878 1.23367 +121 1 4.74402 1.66109 4.92978 -19.7446 -31.5867 36.4561 +122 2 3.83516 1.95374 4.92736 -8.28526 7.01041 1.88485 +123 2 5.14187 2.10852 4.23181 25.7722 28.9669 -41.4039 +124 1 15.0327 12.6922 16.4463 -14.1895 -13.4373 -36.9651 +125 2 14.5853 13.1594 17.1179 -4.44761 17.5587 33.5367 +126 2 14.3173 12.6168 15.7704 28.0544 -5.79477 6.54775 +127 1 15.7455 18.4472 16.8494 -36.7721 -17.2537 -45.0168 +128 2 16.3082 18.5742 17.5575 42.6678 12.9246 46.9817 +129 2 15.6033 17.4929 16.845 -6.46687 1.33922 -4.84851 +130 1 1.19925 1.17644 16.5482 3.81725 -14.252 -17.647 +131 2 1.9494 1.76296 16.5282 11.9166 8.08174 5.38627 +132 2 0.720072 1.41993 17.3243 -10.8728 8.87917 17.8692 +133 1 18.1194 4.51517 15.8978 -9.12682 11.3324 16.5545 +134 2 18.3907 3.99589 15.1624 6.35448 -14.0345 -18.3092 +135 2 0.212938 4.54105 16.5062 3.72114 1.23331 1.72655 +136 1 12.2575 16.9791 16.1441 20.307 19.4582 -44.4732 +137 2 11.5756 16.5974 16.6415 -35.2707 -20.5418 23.5889 +138 2 11.9443 16.955 15.2053 9.79722 2.45701 21.3583 +139 1 15.9948 2.53341 18.0767 10.9381 -15.7258 5.9061 +140 2 15.4972 3.23449 18.4655 -6.78731 22.0319 12.1926 +141 2 15.8185 2.63494 17.1497 -1.81081 -2.22204 -19.1287 +142 1 6.71322 13.8205 10.2184 4.21251 -0.72826 -19.8354 +143 2 6.51318 13.5527 11.1172 -1.15071 -8.01371 4.0626 +144 2 6.63912 13.0526 9.6212 -3.83744 4.98216 12.3358 +145 1 10.1462 18.2988 2.74675 -22.097 -20.0437 20.6404 +146 2 10.3757 0.350258 2.15404 6.85623 19.4082 -18.4799 +147 2 9.18692 18.1396 2.61143 20.6475 -0.265938 -2.33946 +148 1 3.01179 17.7216 6.11391 16.3646 11.1083 -7.5066 +149 2 2.20644 17.7129 5.60578 -13.7656 -5.82691 -3.27397 +150 2 3.67703 17.9821 5.44947 -4.29715 -10.1951 11.4126 +151 1 12.5763 16.9057 8.00279 34.6812 6.34788 -19.799 +152 2 11.842 16.3339 7.82778 -18.535 -10.6459 7.52248 +153 2 12.4277 17.4882 8.74445 -13.6741 4.98834 7.73701 +154 1 14.8867 15.2801 8.21669 15.2681 -20.6133 -0.236719 +155 2 14.2473 15.9935 8.15265 -4.83203 2.49296 -8.82369 +156 2 15.4177 15.201 7.39136 -14.8487 16.0275 12.7595 +157 1 17.673 18.2386 0.358056 6.39969 9.72416 1.64776 +158 2 18.5627 17.8182 0.243387 -17.6184 17.4743 1.20562 +159 2 17.7074 0.56338 0.562155 11.394 -25.7036 -4.78753 +160 1 0.840605 10.4115 1.35744 37.4959 50.4012 -24.017 +161 2 0.0672579 9.99096 1.64345 -42.7842 -22.4511 10.6341 +162 2 0.58692 11.2092 0.808654 3.76922 -28.1369 19.051 +163 1 1.6843 12.2358 3.38047 -6.18426 -19.2714 -7.57792 +164 2 1.35621 11.4726 2.83119 9.65923 28.3457 4.48748 +165 2 1.68469 13.0653 2.87986 -2.69674 -10.3555 -4.68476 +166 1 0.583101 17.235 4.89274 4.80321 -10.1773 15.6529 +167 2 18.7212 18.0548 4.74777 -0.344371 -10.7938 17.6071 +168 2 0.457865 16.8228 5.79389 -3.26711 20.5272 -26.9728 +169 1 1.10197 0.931397 9.43269 -15.4399 -19.3078 -9.02275 +170 2 1.25908 0.443364 10.2575 0.781623 10.2528 -2.87546 +171 2 0.281175 0.525265 9.08113 16.3171 12.9297 7.39947 +172 1 16.7532 2.33623 13.2905 -6.48112 -9.83965 38.5991 +173 2 16.8955 2.59135 12.4052 6.16672 6.51778 -37.0535 +174 2 16.4416 1.41783 13.3009 4.47832 4.66932 -0.969858 +175 1 2.60624 15.8504 12.1681 -27.4943 19.2901 -21.9402 +176 2 3.16839 15.391 12.7532 19.3125 -15.6847 20.968 +177 2 2.92961 15.6774 11.278 4.5792 -4.36857 -3.32021 +178 1 16.4212 15.6424 6.03078 2.33398 -27.7044 12.4884 +179 2 17.3276 15.7008 6.32 9.77501 -6.8374 8.24343 +180 2 16.3266 16.4053 5.49767 -10.7497 25.3256 -21.0495 +181 1 5.80196 5.07502 11.792 -7.0375 5.38003 9.08436 +182 2 5.27256 5.62589 12.4097 12.9595 -6.51078 -10.685 +183 2 5.4277 4.18781 11.8485 -2.70068 5.27459 0.5345 +184 1 15.1729 4.86274 0.750774 -1.10571 10.9128 -33.6343 +185 2 15.2042 4.59535 1.64712 -4.27265 -9.78555 34.3171 +186 2 14.3466 5.34824 0.643665 4.19718 -3.49047 -1.12139 +187 1 16.3347 16.3636 2.07743 2.17372 -8.94604 27.567 +188 2 16.248 16.684 3.01162 -4.2135 -4.93901 -27.3972 +189 2 16.5997 17.1143 1.55727 4.53602 12.7734 -5.95158 +190 1 0.261441 4.84804 3.8055 -0.147017 -56.3045 13.8461 +191 2 0.475233 5.74211 3.84367 9.07909 56.4423 -0.745388 +192 2 0.927869 4.41838 4.37361 -9.48651 2.83213 -9.85838 +193 1 2.95802 15.0603 15.1014 -0.943114 0.172839 -27.3629 +194 2 2.80338 14.7297 15.9709 -3.98201 -9.31011 23.138 +195 2 2.36314 15.8122 15.0164 6.10514 4.60789 3.27938 +196 1 1.13815 14.652 9.54287 -29.9359 -26.3887 42.7894 +197 2 1.85794 14.2975 9.07203 33.137 -5.88851 -26.0645 +198 2 1.02375 13.9289 10.2175 -6.6715 26.0405 -18.8729 +199 1 13.5762 16.6063 11.5459 8.2131 -23.6119 0.793767 +200 2 13.33 17.296 10.9485 -9.11427 22.0857 -7.2987 +201 2 13.1805 15.8285 11.1175 -0.169415 1.89227 9.19008 +202 1 4.67714 1.46335 0.758621 16.4224 4.90719 -8.19047 +203 2 4.16601 2.0159 0.158762 -4.20381 1.9839 -0.0593356 +204 2 4.09672 0.7797 1.07984 -10.7002 -7.55851 6.47825 +205 1 1.4518 18.552 11.8572 6.2605 -28.7314 5.6203 +206 2 1.30143 0.363179 12.6934 -0.382356 1.32639 0.00372943 +207 2 1.68394 17.6168 12.0771 -1.80479 24.861 -1.36748 +208 1 11.5075 10.1198 4.02095 -18.4811 -8.70186 23.5865 +209 2 11.1917 10.5684 3.24759 -2.79925 6.67004 -19.1711 +210 2 12.4478 10.2129 4.02159 23.6747 0.339266 0.782627 +211 1 8.31226 12.1774 3.6909 13.3967 -8.0925 -50.6166 +212 2 9.08853 12.6634 3.95409 8.19758 6.83683 10.985 +213 2 7.73108 12.1161 4.40989 -25.5486 3.81511 42.2514 +214 1 14.4234 4.01167 3.27932 -6.39999 -0.808874 -15.5703 +215 2 15.0318 4.04602 4.01015 9.81333 2.6424 13.2185 +216 2 13.6949 4.61166 3.47516 -0.628596 -1.04819 4.76047 +217 1 5.60276 1.68001 7.51543 46.6974 51.3536 -38.165 +218 2 4.99884 1.09753 7.87161 -47.5789 -43.021 28.4342 +219 2 5.32972 1.80197 6.58421 6.01087 -7.11276 10.7862 +220 1 17.8847 1.08156 4.86879 -16.2479 -18.084 1.95698 +221 2 18.6198 1.37964 4.35055 14.6356 14.0949 -7.48199 +222 2 17.763 1.66674 5.61639 2.20316 6.60999 2.39214 +223 1 6.81142 9.41573 4.49306 -0.655622 0.432156 7.98772 +224 2 6.876 9.60924 5.45033 2.30801 -5.82211 -14.8304 +225 2 7.69814 9.2085 4.16641 0.21776 -0.211816 8.23149 +226 1 2.64622 14.9044 1.97705 -19.6169 -6.34757 32.4999 +227 2 3.24366 14.6749 2.7111 -2.05224 3.38495 -12.0409 +228 2 3.14951 14.9574 1.1885 18.3224 0.185563 -21.7099 +229 1 17.3026 12.9105 13.1506 5.97988 10.8617 -4.35729 +230 2 16.4943 13.3715 13.3508 -17.5214 -4.76439 4.13034 +231 2 17.8495 13.6655 12.9025 6.83053 -7.65676 -2.15198 +232 1 14.953 10.5544 1.38215 35.2581 29.1908 17.9973 +233 2 15.5812 11.2612 1.74238 -25.4064 -29.0048 -15.0024 +234 2 14.0938 10.9575 1.42777 -9.92862 1.12257 -1.65093 +235 1 5.7132 6.77849 4.57909 1.57168 19.8101 -12.7812 +236 2 6.1646 7.64962 4.62346 -11.1008 -12.4177 -0.29751 +237 2 6.30742 6.13992 4.97063 6.93571 -3.41618 11.3539 +238 1 8.02607 8.31482 10.3199 -6.67367 -6.11991 -5.1902 +239 2 8.5826 9.1064 10.2496 0.567217 -7.04018 -13.4516 +240 2 7.81744 7.96553 9.42928 8.80325 8.4252 13.4279 +241 1 13.463 18.3942 5.75922 18.2094 9.72717 -25.7917 +242 2 12.7029 0.253225 5.44631 -3.25776 3.56949 4.30859 +243 2 13.1448 17.7819 6.40042 -11.4028 -12.4364 22.7676 +244 1 0.157572 2.62906 0.18715 -8.27583 -44.4001 -2.30616 +245 2 17.9404 2.90438 -0.139246 -4.84787 10.7772 1.25282 +246 2 0.728557 3.33866 0.428035 8.4047 29.5908 2.16632 +247 1 12.7834 11.0467 9.74512 50.2143 -37.9981 33.2215 +248 2 11.9361 11.0491 9.39224 -54.8114 3.18277 -19.015 +249 2 12.8684 10.1188 10.1004 3.84712 25.3375 -10.5627 +250 1 0.745434 12.1889 11.0782 -25.5268 2.00553 -1.18025 +251 2 18.4134 12.2219 11.1204 10.6569 -0.780029 -7.62666 +252 2 1.00048 12.4147 11.9671 12.4315 1.99225 10.3147 +253 1 5.08453 7.29937 13.4403 2.24753 -3.99956 1.86213 +254 2 5.64891 7.85147 12.8757 -3.98378 2.58677 10.115 +255 2 5.52437 7.26557 14.3066 0.821915 -2.02828 -9.69703 +256 1 1.22699 6.88005 11.8698 42.6355 29.3241 27.8417 +257 2 0.513102 7.24659 11.3736 -15.3023 8.70694 -9.89945 +258 2 1.76616 7.68013 12.1994 -27.3906 -36.7234 -16.475 +259 1 15.5048 9.56381 12.3059 14.0365 -21.5239 -8.17825 +260 2 15.0446 10.3738 12.2505 -11.2614 35.3449 -7.27588 +261 2 15.2981 9.243 13.1696 0.51668 -8.53923 17.0206 +262 1 16.6213 12.8097 5.50479 11.7533 -20.9364 35.7876 +263 2 16.4281 13.7341 5.58129 -4.58024 20.9264 -6.48074 +264 2 16.496 12.5383 4.61195 -7.15835 1.38375 -28.6034 +265 1 6.25272 9.92074 0.051253 25.5558 -5.2213 19.2814 +266 2 5.65499 10.4134 0.617489 -6.63873 2.74854 -0.55683 +267 2 7.09279 9.88715 0.575545 -19.794 1.5448 -11.6918 +268 1 12.3217 6.11544 4.06855 24.0308 27.0278 -26.8963 +269 2 12.2667 6.69224 3.25542 -0.750296 -12.6773 27.7542 +270 2 11.603 5.51542 4.01585 -23.4349 -14.6267 -3.11795 +271 1 0.228308 12.8043 0.188232 11.1572 0.898125 2.61316 +272 2 0.191448 13.5221 0.829575 -7.01271 0.62324 2.49922 +273 2 18.423 13.1312 18.0517 -4.48315 2.42872 -7.20237 +274 1 3.7281 18.597 8.57641 -7.3642 13.4464 17.6561 +275 2 3.55952 18.0214 7.8301 -5.82536 1.28732 -6.71467 +276 2 2.87154 0.379366 8.79158 11.2944 -8.20129 -4.53508 +277 1 7.45075 17.3023 4.47746 -12.4687 -31.8552 -5.62811 +278 2 7.62794 18.1881 4.68695 9.53175 40.2972 16.7849 +279 2 7.50734 17.3052 3.52795 -1.99738 -6.99443 -12.8094 +280 1 9.24058 17.0897 12.2501 -24.9009 9.53262 -6.54721 +281 2 9.25026 16.4035 11.594 -4.50925 -12.7792 -11.7902 +282 2 10.1098 17.0766 12.5981 28.7243 3.47903 16.8433 +283 1 13.2876 12.9366 7.99409 13.1339 47.0026 -12.7195 +284 2 13.3658 12.2269 8.61754 6.78146 -9.97429 11.7811 +285 2 13.946 13.6564 8.215 -16.5737 -23.9385 -2.8436 +286 1 14.9278 2.97205 15.3542 -22.0243 3.95222 27.314 +287 2 14.2978 2.24466 15.255 3.92553 0.418625 -2.59085 +288 2 15.495 2.9795 14.6023 14.212 -3.72656 -21.152 +289 1 9.88733 15.5502 16.9939 -6.96656 2.06857 9.21519 +290 2 10.3024 14.7219 16.7214 3.24805 0.519307 1.1538 +291 2 9.47388 15.4159 17.8681 4.17307 -0.448199 -10.2742 +292 1 11.3272 8.33778 16.5655 -12.1447 -4.13113 3.07889 +293 2 10.5941 7.97459 16.029 11.4521 -0.447246 11.036 +294 2 11.3675 7.80686 17.3849 -1.98947 6.30133 -12.9317 +295 1 3.91087 18.2078 16.7523 8.10648 -24.8729 2.7978 +296 2 4.29329 17.4751 17.2712 -2.30537 5.45923 -13.1249 +297 2 3.83261 0.235403 17.405 -4.96911 23.3333 9.68201 +298 1 2.20524 4.16671 8.93127 -30.922 4.24465 -33.9389 +299 2 3.10409 4.18899 8.66341 29.7515 -2.18627 -0.590115 +300 2 2.16419 4.10976 9.8632 4.73941 -5.36165 36.7803 +301 1 9.8752 10.3748 9.71669 16.1383 -34.8575 15.3318 +302 2 9.43878 11.1114 9.34267 -12.9257 32.2344 -10.6144 +303 2 10.0704 10.5459 10.6459 0.567735 2.49547 1.17829 +304 1 9.70603 0.859612 10.8594 11.2219 3.05072 8.41213 +305 2 9.26848 0.0594607 11.2011 -2.07101 7.3453 -10.3505 +306 2 9.18365 1.30902 10.1791 -6.8322 -10.1071 2.86508 +307 1 9.20299 15.1273 10.2305 31.122 11.5717 5.63223 +308 2 8.76871 15.6899 9.60445 -9.85228 15.7354 -8.32779 +309 2 8.63472 14.3875 10.3233 -23.0991 -20.0884 3.25194 +310 1 0.96837 9.47951 10.2963 -70.5876 8.50765 14.6853 +311 2 0.835229 10.4182 10.5095 11.9906 -6.34251 -2.52384 +312 2 1.84768 9.33537 10.0919 56.817 -0.102153 -14.2985 +313 1 16.9556 4.85371 8.1764 15.2186 15.5475 -39.5257 +314 2 16.4324 5.61135 8.41217 -10.5813 9.18021 7.17639 +315 2 16.8473 4.22258 8.84986 -2.43363 -23.5078 29.961 +316 1 14.6968 14.7113 0.249291 21.1749 6.84176 -19.9636 +317 2 15.2416 15.0749 0.948116 1.7369 4.80193 6.96981 +318 2 13.9408 14.343 0.670519 -22.6431 -9.26918 11.3127 +319 1 3.62773 11.0513 9.55661 13.6415 -11.4582 11.5887 +320 2 3.64622 11.3868 10.4653 -1.2087 2.23818 -2.33891 +321 2 3.18854 11.7052 9.01978 -9.00441 8.94912 -6.83793 +322 1 11.1486 10.7845 1.39435 -11.9859 -27.9615 14.113 +323 2 11.4982 11.6036 1.1014 8.88176 28.2378 -14.4203 +324 2 10.2242 10.7355 1.11217 4.88573 2.00485 1.40976 +325 1 13.1617 7.12114 12.7848 27.9985 9.25187 0.204961 +326 2 14.1485 7.05909 12.8492 -22.0105 -1.86773 -1.16605 +327 2 12.8387 6.22307 12.8528 -4.13181 -6.51108 -0.646654 +328 1 9.62686 1.89618 0.979059 -11.1933 -2.25437 -17.4068 +329 2 8.86583 1.44793 0.536192 15.085 16.0595 8.12302 +330 2 10.1008 2.43338 0.313674 -4.24921 -13.4265 6.88026 +331 1 10.6169 13.5248 4.60784 -18.2432 -3.19473 -12.9411 +332 2 11.3551 12.9251 4.5569 15.1862 -3.85234 3.34493 +333 2 10.6581 13.9134 5.47279 3.49634 8.81883 14.723 +334 1 14.3649 1.74425 10.9305 5.54735 -12.1033 0.31392 +335 2 15.2006 1.47853 10.5325 -1.1471 -9.04293 -1.43649 +336 2 14.4646 2.6903 10.9924 -3.65076 12.6994 -0.169483 +337 1 14.6084 12.2765 11.688 7.48969 -0.0414248 52.7612 +338 2 15.3889 12.4412 11.1797 12.3837 0.874018 -20.9659 +339 2 13.8613 12.0797 11.1652 -22.2598 -6.69151 -32.5036 +340 1 8.22131 5.06515 9.81151 31.4859 -23.4564 -24.7693 +341 2 7.50576 5.35441 10.3398 -29.672 2.17434 15.6894 +342 2 8.09879 4.11038 9.58602 -2.47918 22.6636 6.16193 +343 1 1.53723 16.856 18.3772 -4.91865 -38.0309 19.5229 +344 2 1.81973 17.2424 17.568 8.52952 11.4507 -22.0862 +345 2 1.68062 15.8825 18.2332 -2.55663 27.9439 5.8223 +346 1 1.48989 17.248 15.3251 -39.2991 7.69546 7.77355 +347 2 1.63979 18.1273 15.7491 -10.9611 -20.0854 -9.27397 +348 2 0.505086 16.9983 15.3475 43.8724 16.6347 0.193712 +349 1 3.67894 5.68848 6.10927 6.21387 -9.44646 -9.55971 +350 2 3.15123 6.21186 6.69497 -13.0277 9.84767 14.8728 +351 2 4.18038 6.32117 5.58457 4.58642 -2.3545 -2.10993 +352 1 12.397 9.46521 14.1943 -11.4291 42.6821 2.6577 +353 2 12.6884 8.68898 13.7764 17.0449 -39.3969 -17.6043 +354 2 12.207 9.20402 15.087 -1.24705 -6.16332 16.3323 +355 1 4.0418 15.2774 6.91931 -38.8927 -2.71008 6.44315 +356 2 3.58633 16.0735 6.61178 -2.62598 -4.70343 -0.502904 +357 2 4.94439 15.4914 6.84844 41.7142 6.1892 -4.79175 +358 1 0.605801 8.58372 14.9539 0.254512 0.326548 7.88367 +359 2 0.527439 9.52499 15.1145 -2.4036 7.40824 2.35469 +360 2 1.30759 8.52231 14.3126 8.3049 -1.83762 -9.50966 +361 1 12.9717 8.29262 10.2927 -22.7594 16.3387 10.1639 +362 2 13.6731 7.84025 9.84078 14.5836 -10.6745 -2.92467 +363 2 13.0109 8.02582 11.2281 0.923047 -2.44701 -11.6389 +364 1 15.3232 7.71175 3.53457 4.84131 -0.438878 0.085747 +365 2 14.6048 7.2242 3.18847 -27.3478 1.70601 -26.568 +366 2 15.5504 7.10949 4.22607 20.3905 5.82918 25.2924 +367 1 17.3123 6.68101 0.0543458 25.2448 -11.5383 1.06581 +368 2 16.8643 5.84811 0.208139 -4.52976 -2.78536 3.6701 +369 2 16.6324 7.27442 18.4294 -24.004 18.1506 -8.07094 +370 1 8.88314 6.92259 7.79709 31.0126 27.4325 -12.7619 +371 2 9.82162 7.25311 7.83141 -27.6614 -7.83044 -3.12143 +372 2 8.85418 6.18364 8.38751 -5.1761 -15.9168 16.933 +373 1 12.3742 0.616612 1.23426 0.620177 6.71182 8.7173 +374 2 13.3152 0.448787 1.38768 -5.31542 -0.309906 -0.296651 +375 2 12.0908 0.227811 0.410291 5.35555 -3.35826 -6.33914 +376 1 5.63073 15.1419 14.5354 -14.6404 -24.282 5.65856 +377 2 4.69276 15.2374 14.754 2.80482 -4.42056 0.607876 +378 2 5.89918 16.0006 14.2671 15.2941 25.5531 -11.1631 +379 1 3.85325 6.46699 1.73385 7.01958 -17.0097 2.38606 +380 2 3.51461 7.31896 1.46783 -8.17546 12.9796 -1.79528 +381 2 4.05434 6.54403 2.67764 -3.63249 4.46552 -6.11981 +382 1 3.88854 11.6061 12.3354 -12.5844 1.40703 6.82309 +383 2 4.76337 11.9285 12.5525 8.64878 0.03141 -1.44708 +384 2 3.2838 12.173 12.8501 6.64476 -9.03704 -9.92286 +385 1 5.37483 3.86954 15.8708 7.06931 -74.8011 -5.77053 +386 2 6.14587 3.26348 15.6611 -29.2279 19.2574 6.80998 +387 2 5.70286 4.72315 15.8147 21.5682 55.4234 -2.96121 +388 1 14.3763 10.2794 4.46201 -32.4101 28.4329 49.0365 +389 2 14.443 9.83621 5.32683 0.971611 4.81404 -7.53945 +390 2 14.839 9.74155 3.87936 25.2894 -34.3452 -37.3821 +391 1 7.80918 17.3929 9.15872 22.1479 -28.1908 5.37522 +392 2 6.96403 17.5587 9.551 -17.6194 9.20761 3.63927 +393 2 7.9906 17.9725 8.42371 -6.45863 11.4679 -7.92664 +394 1 4.50911 14.4925 3.93603 -3.72296 -18.8397 -53.7951 +395 2 4.39275 15.3834 4.18687 0.185157 34.2159 14.5975 +396 2 4.6886 13.9787 4.68865 6.61933 -20.0316 37.8242 +397 1 14.2759 7.39669 15.8018 -25.3443 -8.35453 -18.4147 +398 2 15.2098 7.32722 15.7472 31.3188 -3.09541 -3.64929 +399 2 14.1076 7.77613 16.6483 -2.08075 9.82337 20.7866 +400 1 2.98131 18.2876 1.92072 -8.89863 -34.7534 -28.0783 +401 2 2.43865 17.6277 1.38436 23.5626 24.7731 19.3405 +402 2 2.37413 0.302092 2.22775 -14.7638 14.2119 8.82016 +403 1 7.98427 1.62335 4.57287 -40.8947 -0.445207 11.16 +404 2 7.39585 2.15768 4.00383 13.1095 -6.60943 2.01257 +405 2 8.85324 1.63658 4.22836 26.1363 6.2526 -15.7033 +406 1 2.50726 14.1431 17.6951 16.6159 21.4268 -10.1577 +407 2 1.94925 13.5738 18.1946 -18.2656 -19.6261 9.9334 +408 2 3.40865 13.8863 17.9244 2.82527 -4.33175 1.96247 +409 1 0.811695 1.74837 13.8925 -21.7292 3.59652 4.70406 +410 2 0.795118 1.42008 14.8166 -3.87613 7.88135 -16.9479 +411 2 18.5211 1.96459 13.6307 25.6616 -9.0685 11.0917 +412 1 4.4852 18.6484 13.9168 -33.7534 10.3053 3.09674 +413 2 5.3921 18.406 13.9761 25.2496 -8.78408 2.09715 +414 2 4.08373 18.5038 14.7912 8.14506 -1.30426 -6.00867 +415 1 7.12802 0.652367 18.3595 35.0739 -19.2419 -26.0317 +416 2 7.40845 0.19154 17.5185 -9.63956 16.0629 26.4358 +417 2 6.18456 0.683953 18.3433 -21.3742 6.93569 3.25827 +418 1 16.0657 18.4123 14.0301 53.2891 7.60066 12.7833 +419 2 15.2177 18.2242 13.7261 -48.7282 -11.4797 -7.69178 +420 2 16.0808 18.482 14.9966 -9.66087 4.27341 -2.7923 +421 1 10.0672 4.54369 16.2573 46.2132 32.473 -7.3661 +422 2 10.9795 4.93172 16.0704 -30.9355 -10.7562 9.7222 +423 2 10.2805 3.63455 16.4071 -7.05314 -22.7581 -0.39686 +424 1 15.904 17.802 4.45553 44.7656 -19.4466 -14.3322 +425 2 16.4088 -0.0282793 4.41597 5.24747 5.32524 1.83839 +426 2 15.0633 18.045 4.74212 -51.1512 14.4852 15.4733 +427 1 6.99737 17.3998 13.7879 -47.9218 -2.31875 -13.0268 +428 2 7.40243 17.6398 14.5891 19.7576 8.98543 35.5766 +429 2 7.70074 17.2583 13.1843 23.2619 -4.97282 -20.0499 +430 1 13.2941 6.48376 6.64986 8.60711 15.0683 16.7306 +431 2 13.9993 7.1541 6.49159 -11.9149 -19.7057 -4.80273 +432 2 12.8211 6.29295 5.83939 3.46216 6.87198 -11.4398 +433 1 7.76205 2.3443 9.26472 15.7579 10.991 45.3998 +434 2 7.20759 2.25447 10.0765 8.01487 -1.94761 -18.5756 +435 2 7.26048 2.06297 8.52639 -23.6607 -10.4133 -22.8687 +436 1 15.1706 14.8583 13.6757 15.7984 -16.1031 1.44613 +437 2 15.0167 15.231 14.5413 -6.09806 3.71972 9.46304 +438 2 14.6225 15.2955 13.0407 -11.5903 11.1836 -9.13521 +439 1 9.36431 8.31687 3.74781 -9.55399 11.9025 -3.42765 +440 2 10.1518 8.60925 4.20014 9.2003 9.72282 -0.0746101 +441 2 9.3553 7.37835 3.87681 -0.285781 -17.995 1.20514 +442 1 17.7597 13.5616 16.4405 -12.156 -24.6438 9.82021 +443 2 16.8551 13.2283 16.3395 1.48334 1.58847 4.06975 +444 2 17.7289 14.3961 16.0037 5.37456 23.0458 -12.1714 +445 1 4.95841 10.6088 2.75519 -22.9294 18.7883 -14.1686 +446 2 5.66909 10.277 3.27928 16.3083 -8.75526 16.0734 +447 2 4.6114 11.3873 3.23357 6.81328 -15.8641 -4.024 +448 1 3.73362 8.35206 10.1813 3.02598 13.3252 -21.6654 +449 2 3.8939 9.27056 9.86724 -4.6548 -13.2191 9.23973 +450 2 3.49789 8.39898 11.1021 -0.178845 4.23779 13.7606 +451 1 16.0042 7.01418 6.13738 -12.6879 19.8807 -2.17242 +452 2 16.808 7.4479 6.40937 10.6213 6.47779 2.98579 +453 2 16.2019 6.09716 6.06821 5.44302 -25.895 -2.3467 +454 1 15.1221 7.07483 9.10103 -4.15707 -25.1338 32.4641 +455 2 15.7464 7.4872 9.69859 9.03801 3.43378 3.13104 +456 2 15.1481 7.58948 8.33098 1.37226 23.8896 -40.0507 +457 1 6.35284 13.0135 12.8052 -0.193314 -18.9728 -17.7547 +458 2 7.21044 12.6571 13.0708 -4.00291 0.344811 4.20755 +459 2 6.11805 13.741 13.3614 0.492624 18.505 17.8288 +460 1 12.1195 4.49733 13.0969 -26.0004 -21.5883 -29.3264 +461 2 12.1632 4.68913 14.0325 -4.53328 -3.39715 11.6105 +462 2 11.3073 3.93318 12.8667 31.5163 26.387 18.3053 +463 1 11.3554 8.17046 7.8728 -3.27026 2.45633 -4.65198 +464 2 12.0683 7.62612 7.54639 6.23155 -9.6048 -12.5756 +465 2 11.5676 8.24955 8.79484 1.17104 5.44951 18.1694 +466 1 17.1791 10.8374 7.47157 -22.685 17.097 10.0101 +467 2 17.8401 10.2117 7.26521 25.6893 -28.4186 -0.815308 +468 2 17.2004 11.4333 6.72646 -9.08817 8.64759 -4.95169 +469 1 5.26928 18.1244 11.0251 26.2987 0.0330793 2.18763 +470 2 4.69547 17.8637 11.7317 -9.61751 -4.26247 14.7568 +471 2 4.70076 18.4264 10.3375 -16.9 2.57743 -21.8459 +472 1 7.59635 17.5306 1.81531 -10.9531 4.1869 -25.2725 +473 2 7.77056 16.6988 1.31883 2.24077 21.8764 10.5056 +474 2 7.30155 18.2046 1.15131 11.3055 -17.5184 13.1347 +475 1 1.92843 12.8944 13.5862 -6.59595 -16.5477 -16.8116 +476 2 1.43666 12.2821 14.1316 -5.58333 -5.88714 5.06202 +477 2 2.04362 13.6601 14.1181 9.10211 24.5058 14.6097 +478 1 9.63922 6.76943 14.8194 -3.94612 -18.0692 3.52162 +479 2 9.76751 5.80583 15.0218 -0.27339 26.7602 -8.06829 +480 2 9.98245 6.98264 13.9392 -2.96138 -9.43899 0.82382 +481 1 15.2804 4.29771 10.7711 -7.29951 -1.41697 -0.334277 +482 2 16.1821 4.02615 11.0218 -9.71269 11.8498 1.69675 +483 2 14.9105 4.9568 11.3864 17.8049 -7.45406 -3.59162 +484 1 11.2365 6.16159 0.180514 3.71779 6.92115 0.875598 +485 2 11.3264 5.36714 18.3195 14.2335 -18.3801 -6.22284 +486 2 10.2946 6.26806 0.197414 -17.1549 12.9032 2.71424 +487 1 0.0669242 11.3685 15.0652 13.212 -6.85086 18.3683 +488 2 18.0421 11.4114 14.3938 -11.7915 7.94746 -16.0964 +489 2 -0.126536 12.1197 15.6445 1.80559 0.362507 -3.06694 +490 1 7.04679 9.22841 7.26069 23.2883 20.8536 -5.26127 +491 2 6.49897 8.58869 7.67863 -15.4435 -25.8158 9.46312 +492 2 7.95399 8.89143 7.34084 -8.97527 1.37154 -2.4384 +493 1 18.3457 15.377 12.3544 -10.4554 -0.385944 -2.00928 +494 2 0.632165 15.4053 12.1583 18.2501 2.20759 0.366712 +495 2 17.9344 15.8751 11.6412 -4.56296 -0.981709 -1.73702 +496 1 16.5292 4.37759 5.24858 18.1125 19.5767 -27.8403 +497 2 16.7661 4.20984 6.14013 0.307987 -10.9951 33.7785 +498 2 17.3779 4.70209 4.86684 -19.0742 -11.8317 -4.1687 +499 1 17.7267 3.12899 10.7335 -24.2941 -12.2101 -5.28174 +500 2 18.5902 3.43151 10.9823 20.7538 0.196381 3.18907 +501 2 17.7917 2.2294 10.3565 4.74658 11.2046 4.02468 +502 1 12.2912 0.000462328 10.1205 5.29277 -42.3116 -12.7781 +503 2 11.463 0.345322 10.3908 -30.9755 9.64408 8.62664 +504 2 12.8898 0.704281 10.2182 28.9402 34.0259 3.93413 +505 1 10.3772 9.78855 12.3993 -21.9688 -12.411 -17.7787 +506 2 11.0129 9.78765 13.1014 16.013 1.76066 13.7043 +507 2 10.1738 8.8461 12.2399 4.72709 11.7982 0.616329 +508 1 0.569471 2.8284 7.02034 6.04311 -30.2491 -2.51113 +509 2 0.820763 3.41522 7.71636 2.48105 19.4463 13.5049 +510 2 0.862153 1.97327 7.38155 -6.15059 8.48947 -7.95665 +511 1 0.371359 15.3036 6.90441 -15.8595 21.8666 50.0789 +512 2 0.449232 14.6844 7.65301 -0.190166 17.9034 -2.10351 +513 2 0.621967 14.7945 6.18679 16.5003 -37.2512 -48.0182 +514 1 17.0414 7.00877 15.2159 -22.6634 4.89001 -1.64325 +515 2 17.7376 7.6544 15.0563 8.01654 -6.9456 2.15019 +516 2 17.4056 6.16817 15.5101 9.28872 0.897926 -1.45041 +517 1 9.06316 12.4266 8.08985 69.8766 6.47542 -0.0200154 +518 2 9.44101 11.8026 7.43298 -17.7999 4.13897 6.91255 +519 2 8.14431 12.4062 8.1331 -54.6706 -8.19385 -9.80298 +520 1 1.26891 1.85581 2.9921 11.7044 -8.67905 12.4997 +521 2 0.561231 2.0509 2.38915 -6.84046 11.4219 -12.1453 +522 2 1.65109 2.68456 3.32008 -5.2596 -5.54909 -2.36563 +523 1 4.11753 15.1048 9.79523 4.78264 -4.87511 12.6416 +524 2 3.99332 15.4569 8.91057 5.07926 -2.88804 -4.85995 +525 2 5.03278 14.7822 9.88586 -9.66079 5.58119 -5.37355 +526 1 7.25278 2.18203 14.6254 -0.555581 -14.0599 -5.06396 +527 2 7.1005 1.71681 13.7878 -2.90711 2.6098 7.34806 +528 2 7.71992 2.97108 14.3713 4.55177 12.8631 -2.10328 +529 1 18.557 14.6494 2.1729 -24.7771 22.3853 -4.36836 +530 2 0.778963 15.0461 2.09778 12.8139 1.02797 3.11036 +531 2 17.9275 15.4159 2.12338 10.4684 -24.8222 2.25012 +532 1 9.97282 2.76121 12.909 0.960373 12.9666 17.7509 +533 2 9.84581 2.0662 12.2717 -5.76657 -8.74665 -14.3806 +534 2 9.17654 3.31629 12.9308 6.08178 -3.78367 -5.74316 +535 1 2.89833 8.91803 13.044 14.9503 3.68581 0.826535 +536 2 3.29774 9.80788 12.9186 -7.17545 -13.4779 0.185991 +537 2 3.62224 8.34145 13.3619 -7.75262 8.46695 -4.72395 +538 1 3.21711 8.45664 3.69888 -1.45646 11.2765 -73.7917 +539 2 3.66926 9.20612 3.219 -10.9411 -20.3742 19.6072 +540 2 3.34915 8.55803 4.60102 11.7629 13.1896 57.1484 +541 1 5.60205 7.18882 8.56127 11.7766 6.17403 -13.6051 +542 2 5.73377 6.23122 8.60856 -5.21401 3.91262 5.39773 +543 2 5.15686 7.50265 9.34977 -6.87961 -7.75657 6.1504 +544 1 14.8989 1.38427 1.96946 -15.0866 25.6457 3.84218 +545 2 14.4906 2.19786 2.32837 7.96598 -16.9425 9.74227 +546 2 14.9786 1.62425 1.05302 13.5137 -6.97514 -15.0219 +547 1 8.3539 15.1902 0.828571 -0.607384 -15.7884 -3.69873 +548 2 9.11456 14.9295 1.35098 9.06641 9.90213 6.9538 +549 2 7.64957 14.6447 1.20074 -5.27592 0.575252 -4.39528 +550 1 15.5904 1.35118 7.21966 19.131 18.1941 14.0102 +551 2 15.0458 0.788774 6.70847 -19.486 -21.9805 -16.5491 +552 2 15.0172 2.08736 7.44992 -1.58717 6.06663 4.11757 +553 1 4.99095 13.0428 18.5017 -11.814 -5.03203 -22.7016 +554 2 5.38558 13.1981 0.699871 9.67176 2.40993 22.9792 +555 2 5.69857 13.2122 17.8695 -3.662 3.61759 -0.881885 +556 1 15.3616 8.52427 18.1264 -8.5134 -8.81723 23.808 +557 2 15.7284 8.98559 17.3934 10.1937 15.818 -24.0842 +558 2 15.2728 9.20414 0.16849 -1.83009 -5.75583 -0.912989 +559 1 12.0932 3.04939 18.3516 -14.5656 24.4873 8.42937 +560 2 12.4759 2.51827 0.417994 -2.38649 -9.33387 -9.98316 +561 2 12.2916 2.69447 17.4847 9.72648 -15.0074 2.48816 +562 1 13.2068 12.6815 5.17314 -7.19784 6.47098 -0.665029 +563 2 13.7108 11.8878 4.96601 4.53767 0.295949 3.70661 +564 2 13.3847 12.9363 6.09127 2.00425 -11.4311 -4.02895 +565 1 6.06883 7.14745 0.0914664 -7.81354 22.5487 2.98517 +566 2 5.88319 8.11419 0.19427 8.4279 -22.2037 -4.79949 +567 2 5.22519 6.72532 0.292473 3.10856 -0.243494 3.48057 +568 1 17.7194 15.9325 14.9871 -5.54638 -4.40987 -28.7902 +569 2 16.9069 16.4169 14.9498 -12.3977 10.2544 17.1316 +570 2 17.7594 15.7087 14.0393 19.0068 -3.79668 12.8095 +571 1 13.1727 0.977833 16.5926 -11.6444 6.00991 -1.45652 +572 2 14.0026 0.708875 16.9779 14.0624 -0.886732 -0.671765 +573 2 12.7076 0.152182 16.4397 -1.15444 -5.20647 -2.10321 +574 1 11.0384 14.6069 7.3103 -17.4066 -34.6271 2.52502 +575 2 10.2783 14.0261 7.58336 17.6612 20.778 -3.294 +576 2 11.8174 14.0391 7.44317 -4.14385 7.222 1.39489 +577 1 17.5379 8.55913 2.08836 4.35413 -11.6997 -13.5411 +578 2 16.664 8.39738 2.48219 7.20941 -2.48593 -6.20174 +579 2 17.6519 7.91106 1.34391 -7.20398 14.5397 25.454 +580 1 12.3635 7.91649 1.96817 14.6342 -23.934 -0.413214 +581 2 11.8532 8.69875 2.12901 -10.659 13.0689 -1.52352 +582 2 11.9409 7.3888 1.27378 0.548374 7.65925 3.61612 +583 1 11.9419 14.6308 10.3966 13.4402 32.5881 48.4479 +584 2 12.2905 14.0069 9.8182 12.9115 -34.2012 -37.3181 +585 2 11.0351 14.785 10.1903 -23.9611 0.860738 -9.13817 +586 1 6.84298 6.98317 15.5594 -28.1276 -29.1686 -18.0428 +587 2 7.705 6.91496 15.176 20.6419 5.27277 -3.3528 +588 2 6.85291 7.68491 16.1747 6.25697 23.8787 22.837 +589 1 8.01998 4.63032 13.4448 -35.0292 -26.7707 -36.5428 +590 2 7.42844 4.80515 12.6548 14.5268 -5.56395 32.2217 +591 2 8.43798 5.44118 13.6312 16.8653 30.885 3.99265 +592 1 13.3984 12.173 14.3104 -3.57217 10.7678 8.64565 +593 2 13.233 11.2355 14.1881 -1.19303 -4.98427 -3.70246 +594 2 13.8945 12.4998 13.5522 0.86121 -3.67781 -4.0367 +595 1 14.7231 9.47939 7.26845 -4.38272 9.59825 17.375 +596 2 15.5232 10.0108 7.49545 -18.3981 -9.5314 -3.88615 +597 2 14.0057 9.68134 7.91225 20.1628 1.06432 -13.939 +598 1 12.7179 16.9622 3.14627 23.4566 -37.2939 -10.6207 +599 2 12.9355 17.1415 4.04114 9.03221 7.6908 26.6047 +600 2 12.0213 17.5358 2.94483 -34.3001 33.1559 -14.5415 +601 1 1.10947 7.12267 17.419 -6.10821 -8.12856 16.9857 +602 2 0.178422 7.136 17.6887 4.23762 -2.5375 0.360706 +603 2 1.14096 7.54201 16.5672 -1.29203 8.00191 -14.7545 +604 1 12.8573 5.07319 15.6916 -26.4132 -0.426227 -0.347566 +605 2 13.5067 4.42508 15.4662 18.5417 -18.6841 0.103563 +606 2 13.3354 5.89586 15.6754 6.08426 15.3432 1.29959 +607 1 2.44451 3.37888 5.09109 -12.3042 -30.7639 -30.2825 +608 2 1.89914 3.20439 5.84354 -15.8924 -6.60657 16.2411 +609 2 2.9157 4.14854 5.30475 25.2943 38.046 11.4255 +610 1 8.30318 11.1757 13.537 -17.7368 31.3122 -83.5918 +611 2 8.23756 10.9827 14.4193 9.23305 -26.2584 72.471 +612 2 8.98641 10.7011 13.0548 11.9243 -7.18625 13.6047 +613 1 12.9121 1.44799 13.2982 3.17544 -30.959 19.595 +614 2 13.5829 1.31511 12.6431 13.7174 -5.57278 -14.8203 +615 2 12.5671 2.27513 13.0597 -18.9903 37.7092 -4.23536 +616 1 6.45025 13.6395 2.14169 21.7214 -12.6454 -10.4453 +617 2 5.88722 14.0323 2.78408 -20.3944 14.637 16.9787 +618 2 7.03563 13.0797 2.67163 0.317992 1.20831 -5.89746 +619 1 15.9341 6.54969 12.734 7.51439 18.2634 -8.82177 +620 2 16.366 7.12442 12.0552 -8.93517 -14.9663 18.1444 +621 2 16.3202 6.79095 13.5987 -1.79943 -6.04596 -11.4359 +622 1 16.8134 0.715269 9.59469 1.51011 24.5111 -1.75686 +623 2 16.9773 18.4324 9.6759 -2.99022 -25.9416 6.21625 +624 2 16.4855 0.841275 8.69831 -5.26956 1.43879 -3.58435 +625 1 6.14183 11.6821 8.34851 2.12045 33.7206 2.80541 +626 2 5.25373 11.5769 8.68031 -11.2997 -2.21294 6.8592 +627 2 6.41363 10.8186 8.10997 12.8023 -29.2169 -10.6172 +628 1 2.82878 8.69633 0.366162 65.7357 7.98524 25.914 +629 2 2.25196 8.1872 18.4995 -43.1364 -19.0897 -25.1642 +630 2 2.39827 9.3921 0.850531 -20.8372 5.7472 0.329713 +631 1 10.1125 10.4546 6.55694 -3.88563 -4.31924 12.8938 +632 2 10.5628 9.81084 7.11921 -1.26662 -0.776779 -0.718706 +633 2 10.7076 10.6109 5.83303 6.58413 -0.38446 -16.1853 +634 1 6.75197 15.7318 6.59922 10.1749 2.21511 -7.15796 +635 2 7.21229 16.0038 7.38721 0.121014 2.00215 12.9298 +636 2 7.17446 16.2736 5.9175 -9.12202 -3.23328 -2.5626 +637 1 6.44006 13.071 5.66115 9.01876 9.03356 -0.68679 +638 2 6.7952 13.9213 5.9766 -6.67057 -7.15315 -1.80184 +639 2 6.02558 12.6573 6.41982 -1.29087 -3.79345 3.79648 +640 1 16.7894 12.5351 9.7661 -6.01106 14.3853 23.3751 +641 2 16.9466 11.9627 9.02496 7.22561 -5.83165 -16.8213 +642 2 17.1452 13.4178 9.59292 -0.312151 -9.66884 -5.48162 +643 1 6.11103 2.94777 2.80745 -0.0522908 21.1759 -16.381 +644 2 6.20729 3.87808 2.49328 4.01665 -19.1858 15.5438 +645 2 5.82625 2.47942 2.01203 -2.73031 -5.31149 4.59086 +646 1 10.8562 3.22295 3.2592 5.83487 -6.01133 1.10343 +647 2 10.3184 3.99141 3.45824 -8.06424 0.347936 -1.44444 +648 2 10.5285 2.8344 2.43843 -2.26863 2.18612 2.83427 +ITEM: TIMESTEP +50 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.76267 6.9614 17.9655 18.039 1.32171 0.971735 +2 2 7.88851 7.04905 18.3237 -17.7355 -1.2272 4.07533 +3 2 8.77103 6.18416 17.4071 -1.73171 -4.43635 -4.46665 +4 1 18.7148 8.30367 6.79977 -11.0979 19.7573 -45.8218 +5 2 0.340011 8.13606 5.84126 -7.49685 -0.624375 38.3142 +6 2 0.514278 7.70743 7.38333 14.5888 -19.2797 9.57425 +7 1 8.47639 18.6969 6.83361 -13.2294 -1.25401 8.78355 +8 2 9.37315 0.218195 6.58559 19.0885 2.32763 -3.91705 +9 2 7.98208 0.748711 6.39478 -2.33131 3.58411 -1.86541 +10 1 6.52812 1.78346 11.693 -34.4751 -1.18092 9.20038 +11 2 5.67737 2.21709 12.0036 34.6116 -15.9045 -8.19534 +12 2 6.27488 0.856486 11.479 2.31906 19.7771 3.09659 +13 1 7.04596 5.66579 2.40189 46.2065 -42.3734 -14.42 +14 2 6.39782 6.00892 2.95716 -37.9245 28.3982 32.5204 +15 2 6.93615 6.04049 1.54428 -8.317 15.9019 -18.5798 +16 1 16.2302 10.236 16.0835 20.9593 -16.5275 2.4245 +17 2 17.1756 10.4542 16.2372 -23.2351 0.455296 -7.02457 +18 2 15.6872 10.9657 16.3738 0.757377 12.3052 3.78761 +19 1 10.6519 14.9414 2.32488 9.23959 14.6152 1.78567 +20 2 10.6414 14.4628 3.16471 0.797937 2.29677 -5.70575 +21 2 11.1604 15.7599 2.50148 -7.89724 -14.8548 -1.26363 +22 1 17.1653 8.24769 10.628 -7.00673 -3.15457 9.83212 +23 2 16.8168 8.85992 11.2947 -1.87186 0.196375 -6.64951 +24 2 17.9222 8.68524 10.2369 7.99899 3.60318 -1.68622 +25 1 14.7266 15.9157 16.4191 -13.8739 15.1565 -8.48964 +26 2 13.7936 16.2384 16.3951 24.1732 -8.40377 0.758561 +27 2 14.8582 15.5746 17.3097 -4.06225 -5.68183 -0.795501 +28 1 12.1165 13.3951 0.497647 12.4663 -12.7582 1.83308 +29 2 11.9617 13.3954 18.1814 -7.51799 5.11576 7.21512 +30 2 11.4424 13.8646 1.00511 -0.599491 5.86198 -7.65109 +31 1 9.3022 5.46358 3.98483 37.3 9.28522 -25.3544 +32 2 8.76176 5.25183 4.70521 -26.4917 -13.7331 37.3539 +33 2 8.69012 5.59126 3.27137 -14.2398 -0.31671 -15.324 +34 1 1.75646 4.13824 11.6126 7.13571 -34.631 6.10286 +35 2 1.57168 5.01735 11.8974 -3.49495 27.0073 7.26754 +36 2 2.15491 3.66767 12.3745 -6.50879 7.63382 -13.9832 +37 1 2.03017 6.80422 8.30837 9.29028 16.8447 12.8872 +38 2 2.52076 7.32809 8.97976 -10.1379 -7.93343 -11.4013 +39 2 1.79129 5.98703 8.76166 3.66627 -1.3648 -7.3534 +40 1 5.38278 4.45139 7.96045 1.48715 2.78745 -0.615366 +41 2 5.47525 3.53905 7.69237 2.73507 -15.0654 6.73754 +42 2 4.91072 4.84535 7.233 -11.388 9.54401 -10.9371 +43 1 3.30811 2.94776 17.4802 13.944 -42.282 -21.1312 +44 2 3.9986 3.21817 16.868 2.68053 3.29728 -0.298822 +45 2 3.01647 3.72731 17.8911 -19.397 34.8415 21.3069 +46 1 7.43048 5.35311 6.10326 -4.25319 -13.0158 -27.7806 +47 2 8.09022 5.89476 6.48364 23.034 26.3027 15.5228 +48 2 6.99872 4.97144 6.84559 -15.3695 -14.0963 19.964 +49 1 9.79676 7.01231 12.0156 -14.7328 3.59156 -15.7655 +50 2 10.3705 6.43202 11.4882 -9.23999 6.31012 5.56299 +51 2 9.04301 7.2927 11.4294 23.3546 -9.34629 13.9639 +52 1 14.0089 3.6286 8.06931 13.5755 5.11429 34.4728 +53 2 14.0074 4.36435 7.46412 -2.30693 7.62473 -7.33974 +54 2 14.3705 4.00595 8.91563 -10.4749 -13.1534 -24.8623 +55 1 4.55657 17.1558 3.95973 -9.28017 -24.3455 25.7085 +56 2 5.47914 17.3407 4.055 21.0307 11.7367 -4.03215 +57 2 4.1348 17.6911 3.31263 -3.95253 16.2794 -25.0192 +58 1 16.4751 16.614 10.2504 -32.3258 -7.85569 21.4695 +59 2 15.6275 16.6356 10.7813 29.977 2.99208 -16.9651 +60 2 16.2718 15.9944 9.53771 -1.01186 4.78751 -1.5712 +61 1 1.9619 4.81867 0.319959 -10.9755 -9.70287 -18.0846 +62 2 2.61752 5.08919 0.942567 15.1261 9.15008 18.4356 +63 2 1.74644 5.61951 -0.161427 -5.07436 5.04444 -4.19633 +64 1 11.5961 13.2841 16.3358 -4.45358 14.5896 10.2849 +65 2 11.0454 12.5131 16.3954 -10.7816 -16.1685 4.94665 +66 2 12.1536 13.1064 15.5876 11.3576 1.56581 -12.6168 +67 1 10.1325 11.0245 16.8746 -17.0839 37.329 0.881875 +68 2 10.5383 10.188 16.8005 14.1256 -36.2582 -1.95739 +69 2 9.19072 10.9065 16.7053 -0.138929 -3.60954 1.11764 +70 1 11.7656 17.449 13.475 -8.50487 25.248 2.18402 +71 2 12.3632 17.1066 12.8073 4.24528 -3.45864 -2.0733 +72 2 11.8231 18.4283 13.4081 4.57434 -16.4673 0.201387 +73 1 6.41878 9.35136 12.2283 -7.50229 14.2202 21.4939 +74 2 6.8057 8.89086 11.4896 12.6266 0.651555 -6.79619 +75 2 7.09031 9.88696 12.7035 -9.91308 -10.3657 -12.0835 +76 1 16.2619 12.8358 2.69678 7.42582 31.4023 -4.83963 +77 2 17.0939 13.3284 2.51069 -14.3032 -16.3414 4.28546 +78 2 15.5824 13.5473 2.68145 7.19887 -17.4175 4.43499 +79 1 0.698809 12.6212 5.89369 35.48 3.16674 13.5988 +80 2 0.938081 12.5288 4.97754 4.92149 -4.10163 -12.4931 +81 2 18.4194 12.7439 5.90006 -39.8609 3.63618 -4.1467 +82 1 5.237 16.4363 18.426 1.65878 -0.316472 9.22308 +83 2 5.81108 15.7548 18.0954 4.21498 -13.4949 -13.2329 +84 2 5.56972 16.5656 0.670239 -4.67124 7.34541 5.05152 +85 1 0.592121 7.69947 4.15467 -58.6061 -26.6762 36.9237 +86 2 18.6393 8.0928 3.5307 -12.7545 6.31849 -14.8448 +87 2 1.4218 7.85573 3.82511 72.6481 19.3185 -25.9209 +88 1 3.11983 8.96532 6.48794 54.6199 12.7003 -22.2767 +89 2 3.76913 8.45297 6.98254 -4.7725 1.8296 2.92636 +90 2 2.27977 8.75705 6.803 -46.0396 -12.4219 19.8369 +91 1 7.29807 10.3702 16.2638 20.6686 -0.114663 -24.6428 +92 2 6.66655 10.506 15.5642 -5.16108 2.7891 -5.34334 +93 2 6.78521 10.2638 17.0451 -10.3715 -1.64006 24.8745 +94 1 11.1174 0.987619 5.00277 -7.18116 3.53088 7.25248 +95 2 11.0089 1.86145 4.60844 7.25629 1.31859 -0.585836 +96 2 10.7387 0.391071 4.35918 -2.65397 -7.99376 -8.61355 +97 1 4.35641 2.82374 13.2083 -1.43301 42.1246 -29.6721 +98 2 4.74578 3.12447 14.0221 1.91906 -0.955597 13.0676 +99 2 4.17771 1.91012 13.264 -5.21231 -41.1093 14.0839 +100 1 8.41102 10.1748 1.81577 -7.29686 12.4487 -22.3398 +101 2 8.22152 10.8552 2.46036 0.4991 6.95458 5.373 +102 2 8.69583 9.43786 2.3232 10.7851 -24.1065 14.6426 +103 1 10.4306 1.70557 15.5491 18.4702 5.47966 -9.86629 +104 2 11.3921 1.67519 15.3716 -14.7227 -5.4908 8.94093 +105 2 10.0695 2.09393 14.7416 -3.28742 -2.92827 -1.64813 +106 1 2.67775 12.9037 7.82287 3.09642 7.69249 12.8714 +107 2 3.27779 13.5956 7.51776 -0.922255 -1.64886 -5.76029 +108 2 2.01429 12.7843 7.13996 -0.0248334 -2.64481 -5.98892 +109 1 3.74038 11.6511 5.07858 19.3958 17.4162 2.05128 +110 2 3.60589 10.7736 5.39333 -4.06789 -18.6575 13.0804 +111 2 3.07486 11.8033 4.42286 -17.2397 4.77378 -8.56343 +112 1 6.72135 14.4316 16.9296 11.8603 14.2358 -0.0778856 +113 2 7.64698 14.6853 17.0511 -5.38436 -3.23295 2.03342 +114 2 6.43726 14.8986 16.1349 -2.65892 -7.20284 -3.09426 +115 1 14.1884 14.544 3.35185 -21.8252 -0.368401 10.0779 +116 2 13.5247 15.1958 3.05461 14.5314 -4.887 4.26149 +117 2 13.7567 14.0734 4.09815 10.0173 4.52685 -16.1607 +118 1 8.41325 18.11 16.0503 -13.4237 14.7481 -2.40694 +119 2 9.01353 17.4146 16.1754 14.4883 -45.0972 12.851 +120 2 9.02228 0.139466 15.7926 3.66197 31.0187 -5.55304 +121 1 4.74026 1.68368 4.91774 -8.81747 -38.2992 48.653 +122 2 3.89365 2.07173 5.09257 -16.8489 9.86366 -0.181142 +123 2 5.05165 2.08173 4.1548 23.8621 30.7653 -48.3713 +124 1 15.012 12.6397 16.4637 21.182 -20.8114 -27.7575 +125 2 14.6363 13.1316 17.1743 -19.1608 12.2632 11.0748 +126 2 14.4002 12.4571 15.7145 4.23163 12.8017 20.733 +127 1 15.7141 18.464 16.8736 -48.8091 1.63943 -48.6642 +128 2 16.4537 18.5656 17.3974 52.451 1.55627 42.8989 +129 2 15.6088 17.527 16.6934 -4.99653 -8.13868 6.26406 +130 1 1.24245 1.19714 16.5568 -3.35795 -9.15112 -9.15157 +131 2 2.06126 1.67967 16.5955 12.2536 9.19 1.95012 +132 2 0.738255 1.56007 17.2754 -9.1343 5.49748 13.2621 +133 1 18.1403 4.48045 15.9024 -8.92064 9.41796 12.6958 +134 2 18.2534 3.91822 15.1507 3.10214 -9.7063 -13.7449 +135 2 0.333051 4.53253 16.3579 6.8431 0.540548 1.72555 +136 1 12.2576 16.9773 16.1451 24.3374 26.4028 -39.8206 +137 2 11.5235 16.7559 16.6626 -39.484 -19.8089 22.2101 +138 2 11.9275 17.1263 15.229 8.36672 -7.61232 16.8746 +139 1 16.0311 2.54163 18.1267 15.2184 -17.5558 18.8253 +140 2 15.6351 3.35325 18.4083 -9.02057 20.5203 4.48377 +141 2 15.9018 2.48695 17.1953 -7.32995 1.76863 -25.4669 +142 1 6.72575 13.8191 10.1968 -9.26978 -14.9128 -14.7006 +143 2 6.45064 13.4802 11.0509 2.35225 3.79258 9.11016 +144 2 6.47529 13.1065 9.58166 7.75573 8.69288 2.20437 +145 1 10.1667 18.3423 2.73278 -21.0918 -24.4685 17.5154 +146 2 10.3808 0.422697 2.17354 8.51297 19.7321 -20.8009 +147 2 9.25877 18.0911 2.47579 12.4496 3.13566 3.08398 +148 1 3.02618 17.7182 6.12046 9.12785 6.17449 -5.85825 +149 2 2.19895 17.4959 5.67953 0.482163 3.05546 -3.6427 +150 2 3.66706 17.9189 5.4073 -11.2068 -9.39986 11.0759 +151 1 12.5962 16.8879 7.98687 8.69067 0.386489 -7.96768 +152 2 11.911 16.2378 7.93697 -12.2796 -18.2514 -9.64148 +153 2 12.3467 17.3792 8.75804 4.49939 18.0195 12.184 +154 1 14.8895 15.2713 8.19847 3.78441 6.77747 -24.1674 +155 2 14.0908 15.8092 8.10802 0.530475 -1.70182 9.59272 +156 2 15.3507 15.4528 7.3473 -4.11878 -7.96121 22.2836 +157 1 17.7044 18.2264 0.345927 53.2191 22.2557 3.1655 +158 2 18.611 17.8064 0.306571 -34.334 1.581 -6.33561 +159 2 17.9464 0.534475 0.465882 -17.8927 -21.106 -0.514669 +160 1 0.816649 10.4426 1.34739 14.8692 48.9775 -23.6448 +161 2 0.0612409 10.0129 1.68761 -29.4632 -23.0248 11.5333 +162 2 0.465717 11.2339 0.843051 15.2672 -28.7963 15.4324 +163 1 1.72991 12.2406 3.39174 -15.9976 -2.88445 -44.3457 +164 2 1.42407 11.5936 2.70825 8.45982 5.87631 22.8389 +165 2 1.72198 13.0652 2.87637 5.68226 -3.3333 12.0496 +166 1 0.611993 17.231 4.90821 -34.3512 10.3394 53.8078 +167 2 18.7649 18.0776 4.93361 14.0145 -8.94618 -14.8948 +168 2 0.320128 16.8659 5.79609 20.9887 -2.41003 -36.5782 +169 1 1.10304 0.897417 9.42158 -11.0752 -12.4205 -5.86027 +170 2 1.33193 0.471936 10.271 -7.8206 6.77035 -10.9921 +171 2 0.260273 0.49253 9.11811 18.1645 10.0729 11.6017 +172 1 16.7431 2.34345 13.2996 -3.12231 -7.25082 27.0749 +173 2 16.9139 2.55723 12.403 6.00909 8.65593 -29.5603 +174 2 16.479 1.41627 13.3001 1.0866 -1.80785 3.13205 +175 1 2.64585 15.864 12.1283 -21.2463 14.7527 -7.08654 +176 2 3.15605 15.3934 12.7599 11.6364 -10.3414 18.5671 +177 2 3.00262 15.6045 11.2815 4.79088 -2.17896 -11.8296 +178 1 16.4298 15.6598 6.07287 -23.7839 -45.9221 18.6798 +179 2 17.316 15.6562 6.39936 21.0579 5.20152 4.08476 +180 2 16.3078 16.3335 5.44341 2.1367 33.4546 -25.3893 +181 1 5.80337 5.0927 11.7988 -16.1764 10.2154 8.68093 +182 2 5.24436 5.75105 12.277 17.1169 -11.9851 -7.24057 +183 2 5.28663 4.27668 11.796 1.81497 4.13117 2.00496 +184 1 15.1635 4.86687 0.779797 10.276 15.6296 -42.8981 +185 2 15.0374 4.47718 1.61189 -4.55383 -15.7546 43.9488 +186 2 14.356 5.34586 0.597493 -2.57536 1.02491 -2.93315 +187 1 16.3458 16.3763 2.04771 3.47576 3.66541 23.8501 +188 2 16.2044 16.7006 2.97252 -3.72753 -7.68524 -25.3267 +189 2 16.7389 17.1226 1.58867 -0.552753 3.82143 -4.99822 +190 1 0.255881 4.83863 3.82235 -11.3764 -61.9515 -5.66134 +191 2 0.347221 5.7447 3.93716 8.7619 60.1171 8.48532 +192 2 0.834328 4.39842 4.45398 2.37129 4.71095 -1.99834 +193 1 2.9563 15.0569 15.1257 1.71124 8.82343 -41.1566 +194 2 2.85861 14.8634 16.033 -5.32392 -14.5435 34.6784 +195 2 2.48389 15.8911 15.0234 3.12674 0.885842 0.387353 +196 1 1.13777 14.6522 9.5263 -30.3315 0.106042 24.0606 +197 2 1.89024 14.3075 9.07024 17.4708 -15.5826 -4.95385 +198 2 0.933623 14.0402 10.2733 8.29602 9.54759 -23.1661 +199 1 13.5292 16.584 11.5416 25.6454 -21.6132 21.0377 +200 2 13.328 17.2834 10.9465 -13.4726 19.9213 -18.5602 +201 2 13.2496 15.765 11.1158 -9.99742 3.11837 -0.28929 +202 1 4.66126 1.44669 0.76776 24.0608 13.759 -10.2694 +203 2 4.19513 2.00271 0.14116 -5.95148 5.85957 -2.67997 +204 2 4.06121 0.755814 1.00952 -11.6339 -11.0076 11.757 +205 1 1.46276 18.5641 11.8468 9.16484 -20.9655 21.4802 +206 2 1.29795 0.448688 12.6433 2.09315 -1.75191 -4.75625 +207 2 1.84947 17.7191 12.1761 -6.39306 18.521 -9.12508 +208 1 11.4915 10.1299 3.99438 -29.0311 -19.3551 44.8744 +209 2 11.2201 10.4871 3.17848 -8.25775 15.5063 -35.6965 +210 2 12.4189 10.233 4.02648 37.0944 1.09916 3.99775 +211 1 8.27499 12.1796 3.66337 18.6814 -7.12196 -36.2468 +212 2 9.0689 12.5922 3.98877 11.875 7.24467 3.22649 +213 2 7.6764 12.2152 4.36849 -32.1167 2.17346 40.1921 +214 1 14.4874 4.01368 3.28039 -17.5005 -0.0616197 -21.9184 +215 2 14.9648 3.93911 4.08552 21.5727 -0.139675 21.9436 +216 2 13.7566 4.60071 3.48465 -5.84393 1.34015 1.64127 +217 1 5.62374 1.66322 7.51635 70.0554 58.4457 -44.6253 +218 2 5.02312 1.16941 7.9611 -67.4835 -53.4064 45.1295 +219 2 5.39821 1.60037 6.57846 0.425083 -1.20148 0.902483 +220 1 17.8844 1.0604 4.85627 -10.0966 -7.93422 8.12116 +221 2 18.57 1.49808 4.37578 15.6561 4.82809 -15.3219 +222 2 17.6975 1.64814 5.58583 -4.12013 1.11537 7.77052 +223 1 6.80576 9.4106 4.49942 14.9318 -4.14838 16.3077 +224 2 6.92469 9.61899 5.44741 -8.81338 -3.93454 -14.2946 +225 2 7.68422 9.10473 4.22333 -4.88591 1.73472 -0.668879 +226 1 2.61188 14.876 1.98504 -6.91902 -4.93882 19.1315 +227 2 3.25848 14.7083 2.68056 -2.68924 0.660774 0.84214 +228 2 3.12462 14.9058 1.19269 5.2127 1.18228 -19.2613 +229 1 17.303 12.9246 13.1525 10.3788 -12.5807 -3.95397 +230 2 16.4389 13.2985 13.3385 -0.36563 10.0164 -0.276732 +231 2 17.9169 13.6449 12.9311 -14.7092 -1.11942 1.9762 +232 1 14.9246 10.553 1.38722 24.8563 30.4026 18.8772 +233 2 15.5245 11.2788 1.76222 -27.4309 -28.2887 -15.3922 +234 2 14.0162 10.8271 1.54897 4.06804 -0.689498 -1.36825 +235 1 5.72717 6.70809 4.58418 -6.56467 23.581 -8.85087 +236 2 6.06385 7.62371 4.66236 -8.01259 -10.4186 -5.73866 +237 2 6.2767 6.1943 5.16785 8.48743 -6.29877 6.22452 +238 1 8.0009 8.33508 10.3687 14.1913 1.83663 -35.3126 +239 2 8.52082 9.13006 10.161 -0.0651459 -5.63876 7.89795 +240 2 7.94932 7.91253 9.48819 -6.75295 -2.00865 18.056 +241 1 13.4409 18.4268 5.72382 16.6357 0.722738 -15.7997 +242 2 12.6296 0.221713 5.47389 -5.04693 11.9449 -2.85301 +243 2 13.1936 17.8965 6.46343 -5.47963 -14.8645 21.1785 +244 1 0.0859293 2.63743 0.236192 -9.12202 -35.143 -2.56963 +245 2 17.9325 2.9505 -0.168165 -24.3821 -4.07692 -4.34214 +246 2 0.590564 3.4143 0.297916 33.333 32.0117 7.87133 +247 1 12.8395 11.0444 9.74231 45.1743 -31.9509 26.4779 +248 2 11.9686 11.0602 9.42407 -43.5447 -1.91263 -10.9888 +249 2 12.9558 10.1388 10.1456 -3.41612 23.6256 -14.6869 +250 1 0.710059 12.1592 11.0756 -10.531 -0.362272 -11.4251 +251 2 18.3753 12.1255 11.106 13.0957 4.94421 7.25875 +252 2 1.07349 12.4339 11.9177 -3.83141 1.58371 11.017 +253 1 5.10203 7.3136 13.4291 15.7719 5.5957 -0.396148 +254 2 5.6162 7.93373 12.8769 -6.75271 -3.40235 8.70115 +255 2 5.62723 7.25347 14.2483 -7.64248 -3.9813 -9.01905 +256 1 1.21129 6.85545 11.8946 29.9494 36.4661 12.0403 +257 2 0.485742 7.25442 11.415 -4.88796 -0.516932 -2.56673 +258 2 1.80546 7.64481 12.127 -26.2797 -36.2571 -7.59378 +259 1 15.5076 9.61367 12.3051 21.7085 -42.1446 -13.9552 +260 2 15.1772 10.4675 12.1584 -16.5272 42.565 -1.064 +261 2 15.3545 9.37182 13.2055 -3.21788 1.51701 18.7315 +262 1 16.6116 12.7513 5.5295 7.16384 -7.58562 22.1279 +263 2 16.3878 13.6701 5.61583 -3.61437 18.1746 3.54477 +264 2 16.4616 12.5615 4.61757 -3.38991 -5.42355 -25.0954 +265 1 6.3014 9.86096 0.0280098 12.3864 1.00447 14.78 +266 2 5.6246 10.4136 0.42972 -1.13337 -0.2267 2.50286 +267 2 7.03571 9.82087 0.686012 -15.2579 5.10695 -14.0237 +268 1 12.3034 6.12839 4.06739 18.1147 15.8957 -28.6536 +269 2 12.3348 6.66771 3.23063 -4.28261 -10.1618 29.3394 +270 2 11.5855 5.52112 3.9529 -14.8183 -8.35162 -1.01689 +271 1 0.289245 12.8118 0.17396 1.00074 4.7721 1.62068 +272 2 0.031574 13.4709 0.828681 0.933398 1.09562 1.96647 +273 2 18.4473 13.0492 18.0252 -3.3255 1.79332 -7.06642 +274 1 3.67377 18.6092 8.59256 -12.2718 12.3972 8.90671 +275 2 3.51633 18.2244 7.72678 0.0355868 -3.61867 -2.60117 +276 2 2.80982 0.36536 8.82196 13.0622 -5.69839 -0.636093 +277 1 7.44701 17.3263 4.47819 -12.2479 -42.1382 8.27198 +278 2 7.47198 18.2285 4.71954 7.46065 34.1282 3.2472 +279 2 7.59543 17.2523 3.54279 -0.328999 6.68987 -14.4609 +280 1 9.24493 17.1077 12.2387 -39.9724 15.9122 -7.56371 +281 2 9.27102 16.3677 11.6468 4.90539 -16.8252 -9.88175 +282 2 10.091 17.2207 12.6154 35.0883 -2.17581 15.9571 +283 1 13.2831 12.983 8.01599 31.7457 23.9761 -1.258 +284 2 13.3856 12.1913 8.53584 -3.88389 -9.78552 5.15809 +285 2 14.1414 13.4672 8.16531 -29.1617 -3.59582 -8.01118 +286 1 14.8948 2.98524 15.3712 -17.5751 0.764594 21.5491 +287 2 14.1876 2.34218 15.2724 -1.25262 -5.58382 2.64656 +288 2 15.4061 2.89645 14.5861 17.2961 2.13088 -20.5882 +289 1 9.89537 15.5662 16.9902 -4.09035 4.17693 9.89685 +290 2 10.2983 14.7234 16.7502 5.73332 1.10161 -2.59445 +291 2 9.67249 15.5035 17.9343 -2.60097 -1.56266 -9.87078 +292 1 11.3274 8.38795 16.5853 -21.4847 -13.5698 4.02619 +293 2 10.6433 7.93033 16.0536 12.1725 7.69909 5.41873 +294 2 11.2563 7.95351 17.4557 6.17465 6.37506 -11.4872 +295 1 3.9593 18.2162 16.7697 0.697619 -14.1615 -14.1273 +296 2 4.40283 17.477 17.2226 -3.01571 14.2153 3.03122 +297 2 3.77495 0.26362 17.3949 3.98021 5.349 11.1126 +298 1 2.22376 4.19593 8.92134 -23.2189 1.10906 -21.9008 +299 2 3.13693 4.25168 8.71451 27.6214 0.869066 -8.80864 +300 2 2.192 4.13003 9.85498 -3.77747 -6.53541 33.4183 +301 1 9.87956 10.3806 9.72418 15.1316 -34.7661 11.7533 +302 2 9.43202 11.1334 9.41625 -17.3542 37.4051 -17.5479 +303 2 10.0318 10.5223 10.6578 4.66737 -1.93825 10.7585 +304 1 9.70627 0.903434 10.8708 -16.6391 -17.8124 -8.64764 +305 2 9.32253 0.0380009 11.0933 9.22807 5.63208 7.52542 +306 2 9.08638 1.2149 10.1967 9.10725 8.78511 -0.274781 +307 1 9.19757 15.1031 10.2247 30.2853 16.2782 3.75492 +308 2 8.7691 15.7671 9.69642 -6.57671 14.9232 -6.79792 +309 2 8.58248 14.3993 10.2376 -24.9838 -23.9988 3.33467 +310 1 0.938497 9.56303 10.2766 -19.6808 1.12411 10.869 +311 2 0.864208 10.4264 10.69 -4.58503 2.29603 -0.877129 +312 2 1.8082 9.5891 9.92621 21.6362 -6.44505 -13.6115 +313 1 17.0002 4.85339 8.15215 21.2107 4.17599 -32.9154 +314 2 16.5226 5.60356 8.44909 -16.9553 23.1583 5.35412 +315 2 16.856 4.21761 8.81327 -1.81027 -27.4365 28.1652 +316 1 14.7301 14.7112 0.178334 14.6842 0.804622 -15.2869 +317 2 15.1474 15.2511 0.844024 6.42123 6.45952 11.8737 +318 2 13.9865 14.3021 0.591484 -20.7841 -7.92944 9.37323 +319 1 3.69091 11.0487 9.53568 5.98335 -8.96355 13.8332 +320 2 3.56651 11.2839 10.4631 4.16949 4.48414 3.3219 +321 2 3.23005 11.7193 9.04032 -8.2098 7.45463 -11.8198 +322 1 11.2005 10.7579 1.45634 -8.62161 -19.8695 4.90197 +323 2 11.5404 11.5862 1.17391 12.694 26.4047 -12.3165 +324 2 10.2904 10.7467 1.15081 -4.44873 -2.97897 0.910453 +325 1 13.1494 7.14877 12.735 25.4211 -2.46103 0.847156 +326 2 14.1287 7.02261 12.7655 -19.3043 2.68773 1.11168 +327 2 12.7806 6.27183 12.8763 -3.1166 -1.04351 -1.25783 +328 1 9.62343 1.89491 0.979311 -12.9604 6.63616 -29.4885 +329 2 8.7946 1.64267 0.49669 19.6199 4.62861 14.6045 +330 2 10.1494 2.42868 0.345455 -5.12075 -11.8177 11.3147 +331 1 10.6335 13.514 4.5646 -17.0056 -0.486025 -1.57099 +332 2 11.3585 12.913 4.68456 17.6411 -7.84828 -0.965736 +333 2 10.6299 14.042 5.36013 -0.769181 5.74096 10.189 +334 1 14.4133 1.73933 10.9414 -11.8391 -17.207 6.29742 +335 2 15.2077 1.35218 10.5638 5.14778 2.73806 -3.87278 +336 2 14.5015 2.69292 10.9149 5.22965 5.71868 -2.86675 +337 1 14.5722 12.1975 11.686 14.094 -1.05888 37.2495 +338 2 15.3017 12.3928 11.129 31.2021 7.92611 -10.369 +339 2 13.8916 12.0994 11.0714 -43.9062 -9.54665 -27.6985 +340 1 8.20779 5.06885 9.81189 17.2837 -27.279 -13.9945 +341 2 7.476 5.2926 10.3565 -21.7486 9.79802 13.7153 +342 2 8.11585 4.0945 9.69767 5.61634 21.6585 -4.44102 +343 1 1.51211 16.8659 18.4077 -7.21278 -21.5738 6.32543 +344 2 1.92778 17.2486 17.641 3.99023 3.9685 -12.2343 +345 2 1.4425 15.9033 18.1995 7.9863 23.2313 7.90302 +346 1 1.50475 17.27 15.3217 -52.6385 22.4638 18.049 +347 2 1.49283 18.1952 15.6793 7.67726 -26.1665 -10.1971 +348 2 0.544177 16.9836 15.4083 37.5739 4.67989 -9.3974 +349 1 3.64958 5.72975 6.08508 6.29069 -26.5723 -11.3796 +350 2 3.20343 6.25343 6.73323 -12.457 15.9806 12.721 +351 2 4.14586 6.29176 5.4852 3.70859 6.95385 1.18178 +352 1 12.4272 9.46789 14.1967 -22.2867 60.9428 4.59069 +353 2 12.8141 8.72569 13.8244 25.5413 -52.6107 -24.0302 +354 2 12.2248 9.22264 15.0865 -2.36671 -8.29514 20.866 +355 1 4.05215 15.2773 6.93811 -37.3363 -16.6714 15.1212 +356 2 3.52112 16.0418 6.69595 1.88806 4.21981 -3.16255 +357 2 4.93922 15.5036 6.7631 37.0693 10.9568 -7.31607 +358 1 0.634621 8.6113 14.9988 -1.00168 -8.57623 6.03626 +359 2 0.426563 9.53409 15.1284 -0.450123 11.8509 1.14186 +360 2 1.36493 8.60238 14.3834 7.02364 0.17651 -8.78598 +361 1 12.9488 8.28918 10.2591 -12.3232 2.05195 12.3522 +362 2 13.6164 7.77926 9.80228 8.67745 -2.84232 -3.45719 +363 2 12.9296 7.914 11.161 -0.920073 6.75149 -12.343 +364 1 15.3287 7.72887 3.53701 30.7324 40.0945 -27.1654 +365 2 14.5687 7.40616 3.08394 -23.025 -16.3354 4.19175 +366 2 15.5452 7.39964 4.39595 -10.5646 -17.2283 18.769 +367 1 17.3078 6.69366 0.0430756 19.9915 -9.88107 5.38445 +368 2 16.7705 5.94464 0.294276 -4.0765 -7.9871 3.32428 +369 2 16.6874 7.33606 18.3865 -21.7939 19.8828 -6.94939 +370 1 8.91017 6.93043 7.77699 23.4025 28.7729 -7.70378 +371 2 9.81824 7.33337 7.84479 -23.824 -15.1706 -1.9244 +372 2 8.86104 6.22236 8.40836 -0.772968 -13.4081 16.1446 +373 1 12.3843 0.611213 1.25908 1.98263 -0.697807 -4.79042 +374 2 13.323 0.393307 1.31761 -0.925839 8.32556 5.35041 +375 2 12.1237 0.465738 0.350227 -1.33982 -4.5367 -2.71568 +376 1 5.61465 15.1448 14.5392 -1.26631 -30.1046 6.25467 +377 2 4.66418 15.2406 14.6702 -0.2102 4.52428 0.84195 +378 2 5.97383 15.921 14.1393 5.11494 24.4221 -7.05072 +379 1 3.84895 6.44034 1.72963 2.7696 -8.11358 7.79979 +380 2 3.51864 7.3032 1.48291 -7.06055 11.1725 -5.60147 +381 2 3.99368 6.51729 2.68239 -0.0521329 1.22822 -5.4234 +382 1 3.90083 11.5778 12.3664 -12.9911 -8.32668 -3.5509 +383 2 4.78352 11.9371 12.4749 4.25232 1.56379 3.39016 +384 2 3.29545 12.1182 12.8978 7.28302 -2.19426 -6.07273 +385 1 5.34262 3.87885 15.873 -6.15348 -82.0204 -11.7996 +386 2 6.0076 3.23261 15.5032 -15.8888 19.1459 15.4213 +387 2 5.69117 4.71679 15.7838 27.5644 60.3601 -6.10452 +388 1 14.3156 10.2471 4.51115 -35.9806 40.7967 42.7391 +389 2 14.5125 9.92103 5.39777 -3.50802 -2.54983 -0.445713 +390 2 14.828 9.75135 3.94137 33.3968 -38.7315 -40.7643 +391 1 7.75287 17.3919 9.13705 13.5919 -13.2315 -4.02741 +392 2 6.89819 17.6363 9.44363 -21.9658 0.853712 16.3055 +393 2 7.88604 17.9611 8.38483 9.7933 6.77297 -11.9047 +394 1 4.50916 14.5069 3.91348 -1.14645 -26.1805 -53.139 +395 2 4.48781 15.3883 4.18695 -0.715057 47.311 12.47 +396 2 4.59583 14.0061 4.68593 4.03467 -28.7439 39.2156 +397 1 14.2649 7.40032 15.8248 -22.801 -12.9293 -21.4811 +398 2 15.1988 7.32934 15.7188 25.9215 -1.64325 -3.33443 +399 2 14.1282 7.83404 16.6492 -0.714938 9.98648 22.5393 +400 1 3.02257 18.338 1.93829 -9.63799 -32.7056 -36.1055 +401 2 2.55646 17.7535 1.2554 15.187 19.9859 31.9951 +402 2 2.37728 0.279403 2.32429 -11.6166 9.08866 3.80637 +403 1 7.9856 1.63208 4.58686 -21.2194 7.37107 -10.8429 +404 2 7.46714 2.08087 3.89599 -2.9365 -3.17783 11.7342 +405 2 8.82293 1.5175 4.16848 19.7493 -4.53145 -2.81354 +406 1 2.46603 14.1528 17.6814 26.4379 24.7021 -16.3984 +407 2 1.84119 13.6421 18.1459 -27.3849 -25.1212 16.5566 +408 2 3.3203 13.7773 17.9154 6.17156 -2.74614 2.81365 +409 1 0.847673 1.77812 13.8995 -29.1857 4.71799 7.40329 +410 2 0.70153 1.57851 14.8469 9.71331 1.1605 -15.3576 +411 2 18.5888 1.96886 13.5517 20.2657 -3.94578 7.10705 +412 1 4.44078 18.6823 13.9019 -16.0244 4.84661 7.61196 +413 2 5.30649 18.3093 13.8135 20.8517 -5.19628 -2.25594 +414 2 4.21344 18.5423 14.8331 -2.2181 0.553195 -4.50589 +415 1 7.17333 0.707602 18.3659 18.5924 -14.7376 -19.2949 +416 2 7.29313 0.222373 17.5065 -5.17699 16.3575 23.4569 +417 2 6.28409 1.05221 18.4099 -11.4153 -0.902781 0.0516699 +418 1 16.0458 18.3995 13.9929 19.922 2.02833 15.0786 +419 2 15.1358 18.307 13.8248 -34.099 -5.52537 -15.9309 +420 2 16.0494 18.5146 14.948 8.19193 5.7614 4.60276 +421 1 10.1078 4.56818 16.2539 38.806 25.935 -8.65561 +422 2 11.0636 4.83663 16.0361 -35.078 -16.4147 14.4025 +423 2 10.0818 3.61692 16.3176 2.43484 -11.3153 -3.34335 +424 1 15.9163 17.7591 4.46968 32.0074 -29.6155 -15.1132 +425 2 16.5099 -0.143617 4.50341 7.95185 14.4383 0.237761 +426 2 15.1003 18.0575 4.79025 -43.3278 16.7712 13.4837 +427 1 7.00774 17.4246 13.8321 -56.0949 -7.97771 -22.4327 +428 2 7.49162 17.6994 14.5684 25.5375 13.311 41.1471 +429 2 7.64463 17.2266 13.1734 23.6351 -3.93018 -21.4132 +430 1 13.2756 6.47326 6.61789 23.4956 20.1255 -14.8261 +431 2 14.0898 6.99784 6.40679 -18.3755 -16.6425 15.9473 +432 2 12.9103 6.33261 5.73881 -7.54238 -3.20295 2.17295 +433 1 7.79764 2.32743 9.30513 0.620653 -0.611916 41.3127 +434 2 7.26457 2.16571 10.1169 11.5422 6.28076 -11.6799 +435 2 7.22158 2.07024 8.60986 -14.5852 -6.72752 -26.4814 +436 1 15.1722 14.8472 13.687 6.75051 -12.1688 -2.41191 +437 2 14.9232 15.197 14.5358 -2.94711 1.82763 14.9216 +438 2 14.8185 15.4404 13.0388 -8.36185 8.62669 -11.0165 +439 1 9.38377 8.31795 3.7734 -21.5197 15.3047 -10.1967 +440 2 10.1883 8.66352 4.14356 14.5642 4.86611 3.27566 +441 2 9.4002 7.3753 3.8765 5.94621 -16.0238 5.03493 +442 1 17.77 13.5913 16.4331 -7.58631 -31.5789 18.0626 +443 2 16.8485 13.2919 16.3991 0.887673 4.05725 -0.920823 +444 2 17.783 14.4232 15.9937 -0.095827 22.773 -14.6224 +445 1 4.93053 10.5741 2.80353 -17.5831 18.6377 -10.1976 +446 2 5.6584 10.2884 3.33403 15.5926 -12.1878 10.3648 +447 2 4.56303 11.3186 3.30761 3.36544 -9.45409 -4.10473 +448 1 3.72361 8.36764 10.1215 3.29328 14.9495 -8.98506 +449 2 3.89363 9.29817 9.8724 -2.16289 -13.6958 -0.787578 +450 2 3.61222 8.39575 11.0685 -3.0862 -1.08413 10.2171 +451 1 15.9739 6.97387 6.06952 -13.2047 20.7109 0.201327 +452 2 16.7663 7.43242 6.33309 11.9845 5.69104 3.28059 +453 2 16.2425 6.10629 5.81378 6.71976 -25.6546 -0.898294 +454 1 15.1226 7.10933 9.08497 -8.54326 -39.6564 44.8588 +455 2 15.7377 7.52152 9.6861 12.0306 8.12876 4.18876 +456 2 15.1451 7.58697 8.30383 2.04885 32.3579 -51.8464 +457 1 6.29947 12.9646 12.7695 3.37722 -4.66482 -6.66232 +458 2 7.17165 12.6249 12.9809 1.24175 -10.0492 1.61343 +459 2 6.12977 13.6114 13.4445 -6.34808 15.4581 9.54933 +460 1 12.1164 4.51054 13.0962 -37.6646 -34.1548 1.17408 +461 2 12.2607 4.59773 14.0409 7.03003 6.16295 4.50476 +462 2 11.318 3.89029 13.036 30.5495 29.2935 -6.64922 +463 1 11.3767 8.15056 7.89733 -18.501 8.72492 -14.0328 +464 2 11.9999 7.57003 7.45959 11.3303 -6.40222 -0.944592 +465 2 11.6722 8.28384 8.79215 9.56916 -2.23029 14.0742 +466 1 17.1624 10.8628 7.5038 -34.939 16.2827 29.0255 +467 2 17.7665 10.1757 7.31962 29.6392 -23.074 -13.6235 +468 2 17.1223 11.4937 6.79065 1.17945 1.22203 -15.4432 +469 1 5.28569 18.1322 10.989 31.979 0.201705 -2.44437 +470 2 4.81806 17.865 11.7612 -14.4656 -7.34411 17.8618 +471 2 4.63582 18.2948 10.3295 -20.6991 2.34913 -21.9288 +472 1 7.59755 17.5197 1.78957 -4.56355 -5.70379 -23.6831 +473 2 7.90081 16.7255 1.29504 -6.23989 15.492 10.1621 +474 2 7.18064 18.108 1.12072 15.1074 -6.58967 11.1205 +475 1 1.93009 12.8809 13.5782 -3.15102 -7.76664 -18.9393 +476 2 1.45787 12.3423 14.2065 -6.90584 -5.9659 9.51664 +477 2 2.19823 13.666 14.0335 5.43227 17.0545 14.7464 +478 1 9.58089 6.76558 14.8178 3.72821 -35.8509 -10.9213 +479 2 9.75861 5.80832 15.0417 -6.66727 32.4051 0.0155959 +480 2 9.77461 6.83059 13.8656 0.408011 6.2359 8.07479 +481 1 15.2957 4.27102 10.7659 9.27088 14.9202 31.1326 +482 2 16.1322 3.95288 11.1528 -7.49935 1.06904 -21.0932 +483 2 15.0846 4.9939 11.387 -3.9034 -8.13187 -14.3813 +484 1 11.2455 6.18064 0.162868 26.0255 26.7031 14.5737 +485 2 11.4763 5.37121 18.3763 -4.81733 -21.4086 -8.3593 +486 2 10.308 6.3098 0.211594 -20.2553 -5.22819 -8.60243 +487 1 0.00824002 11.3791 15.0352 26.3856 -8.14992 32.1511 +488 2 18.096 11.5216 14.3022 -25.0888 8.62779 -34.0528 +489 2 -0.201285 12.127 15.606 2.8625 2.75044 1.90901 +490 1 7.02689 9.25213 7.27678 19.2929 16.5016 -4.78745 +491 2 6.59278 8.51389 7.67295 -14.5933 -20.8184 8.5158 +492 2 7.9603 9.00351 7.26624 -3.73747 1.30273 -1.02295 +493 1 18.3276 15.3446 12.3362 -3.78489 -4.33158 3.75643 +494 2 0.608087 15.5074 12.1532 11.0792 5.95639 -3.98767 +495 2 17.812 15.8736 11.72 0.968766 1.6464 -4.64437 +496 1 16.5183 4.40219 5.2766 -9.25512 24.5768 -59.2644 +497 2 16.7942 3.98653 6.05327 18.9035 -16.7679 44.3388 +498 2 17.2936 4.55111 4.6869 -10.7937 -7.24122 14.527 +499 1 17.7074 3.16435 10.7411 -7.07567 -19.8863 -1.17515 +500 2 18.5775 3.40914 11.0222 18.8337 10.6004 6.41913 +501 2 17.8312 2.27039 10.3862 -7.09349 4.4518 -2.20884 +502 1 12.3002 -0.0151335 10.1074 11.0606 -47.8945 -14.4391 +503 2 11.4203 0.251866 10.2671 -34.8312 14.3717 9.25421 +504 2 12.8296 0.729107 10.2725 26.3435 36.9272 6.71278 +505 1 10.377 9.78 12.4264 -19.0889 -11.9366 -11.7107 +506 2 11.0349 9.79085 13.1125 14.2042 0.527855 9.4859 +507 2 10.1856 8.83311 12.286 4.63513 11.4958 0.11243 +508 1 0.612468 2.80552 7.03105 -3.16196 -18.6605 -12.6623 +509 2 0.888173 3.44011 7.68312 3.89236 7.11247 14.3448 +510 2 0.935234 1.94488 7.34043 -2.08916 10.0979 2.30791 +511 1 0.333274 15.3197 6.88029 -14.1577 45.9776 55.0939 +512 2 0.45846 14.8119 7.69617 1.50982 5.91417 -3.14315 +513 2 0.483825 14.7581 6.18064 16.8578 -51.3136 -47.9608 +514 1 17.0479 7.0004 15.1603 7.32733 3.15391 4.0553 +515 2 17.7743 7.62519 15.0492 -4.65368 3.90748 -3.79045 +516 2 17.4843 6.26113 15.5911 -6.30626 -9.6282 -1.63315 +517 1 9.09335 12.4409 8.06571 39.5186 -12.5139 -7.54936 +518 2 9.34597 11.7249 7.45783 10.9221 9.9246 5.15013 +519 2 8.17581 12.4072 7.99758 -53.4732 7.6014 3.58329 +520 1 1.26136 1.81045 2.95361 -2.6705 2.40839 8.80735 +521 2 0.548126 2.01955 2.35817 -5.69651 1.92544 -13.4687 +522 2 1.50342 2.66138 3.33407 8.35517 -3.762 3.05283 +523 1 4.10861 15.1005 9.87028 17.6559 -3.6711 -5.25272 +524 2 3.99986 15.4157 8.96812 -4.49733 0.314881 -1.79245 +525 2 5.04559 14.8362 9.90181 -11.0653 1.71965 6.05025 +526 1 7.3044 2.18074 14.6544 -4.4599 -5.38687 1.90914 +527 2 7.13921 1.65822 13.8561 -1.41133 5.62984 3.30149 +528 2 7.58548 3.05039 14.3636 5.58134 3.87352 -5.39735 +529 1 18.5311 14.6245 2.16796 -28.4168 7.73599 -0.688338 +530 2 0.75601 15.0339 2.21782 2.27339 5.70314 -0.294719 +531 2 17.8249 15.3246 2.17516 22.0369 -13.9852 -0.651534 +532 1 9.98569 2.74939 12.8982 -9.19221 10.3282 12.793 +533 2 9.83979 2.05829 12.2602 3.07064 -9.86428 -11.8695 +534 2 9.16543 3.26718 12.8794 9.24196 0.527571 1.01071 +535 1 2.93657 8.90297 13.0427 17.8365 13.1008 0.527628 +536 2 3.20967 9.8454 12.9227 -4.18066 -20.4527 0.554358 +537 2 3.74278 8.43516 13.3493 -16.2822 5.83343 -3.94486 +538 1 3.21464 8.50963 3.72772 0.0178718 14.8284 -74.1155 +539 2 3.59865 9.33251 3.32895 -6.0017 -25.5341 4.84747 +540 2 3.33657 8.62148 4.62381 5.38554 5.83243 67.2306 +541 1 5.61344 7.20035 8.58446 -2.8239 -8.19112 0.0562215 +542 2 5.53456 6.24006 8.54079 8.61958 1.67382 -4.34837 +543 2 5.04066 7.41711 9.32304 -1.21443 9.5719 0.536432 +544 1 14.8964 1.44105 1.93253 -7.61412 -10.5809 19.4064 +545 2 14.4541 2.19461 2.37874 12.2686 -5.42452 -16.4906 +546 2 15.2548 1.628 1.06483 0.86569 15.045 -4.43663 +547 1 8.4154 15.1546 0.810786 1.70028 1.58395 -11.225 +548 2 9.17382 15.0707 1.40016 -1.99176 -3.13146 6.02583 +549 2 7.70673 14.5929 1.15135 2.54266 -0.476233 4.63029 +550 1 15.567 1.36482 7.20444 28.1778 15.3746 16.2283 +551 2 15.0185 0.765154 6.74682 -23.3742 -21.8939 -17.7163 +552 2 14.9729 1.99808 7.60632 -6.19001 12.1291 -0.330309 +553 1 5.0089 13.0207 18.4853 -18.4609 -5.74542 -15.9738 +554 2 5.42479 13.0864 0.690362 9.95106 2.52519 17.0862 +555 2 5.65544 13.3331 17.8473 1.85993 1.51979 0.712767 +556 1 15.3671 8.54929 18.1095 -8.15636 -15.968 22.0227 +557 2 15.6817 9.03573 17.3686 11.3034 18.5085 -22.2724 +558 2 15.31 9.18561 0.190372 -2.38163 -0.236806 -1.34825 +559 1 12.0802 3.07221 18.3457 4.60183 -13.894 -6.42275 +560 2 12.4859 2.4 0.260392 -4.96838 8.65649 13.1594 +561 2 12.2775 2.7013 17.4791 -3.58827 6.63097 -2.22236 +562 1 13.1993 12.6855 5.15579 5.61247 -4.39703 15.9491 +563 2 13.8115 11.9693 4.94018 -5.07495 0.365899 -6.13845 +564 2 13.2564 12.743 6.12308 -1.32671 2.90452 -5.88021 +565 1 6.08204 7.19061 0.120725 -6.90673 14.7019 -8.65455 +566 2 5.87336 8.13986 -0.0835188 5.89552 -25.7895 13.7146 +567 2 5.2676 6.79179 0.465292 5.04542 5.75855 -0.526985 +568 1 17.7014 15.9063 14.9696 22.6091 -4.25312 7.62853 +569 2 16.8618 16.3646 15.0156 -4.32677 -2.50983 -14.3551 +570 2 17.9392 15.6583 14.0532 -15.4152 10.9643 9.19951 +571 1 13.1673 0.955706 16.6058 -16.4624 13.9879 0.0318296 +572 2 14.0199 0.765403 16.9805 16.2653 -3.85138 1.37902 +573 2 12.7278 0.106773 16.5459 -0.203322 -8.12911 -4.60325 +574 1 10.9967 14.5844 7.33958 -18.0316 -21.646 7.99268 +575 2 10.1705 14.1548 7.70673 29.6081 10.2394 -10.7243 +576 2 11.7328 13.9554 7.47718 -10.5059 7.23567 0.829732 +577 1 17.5629 8.52802 2.09087 -9.01192 -26.3923 -8.78708 +578 2 16.6633 8.41226 2.4486 12.6056 4.50253 0.467713 +579 2 17.6588 7.73531 1.50133 0.834193 24.7006 12.2923 +580 1 12.3809 7.87992 1.9744 6.05515 -15.9846 -5.53898 +581 2 11.7749 8.59773 2.10936 -4.35558 14.0343 4.46215 +582 2 11.9629 7.32605 1.30246 4.89043 0.565697 0.45699 +583 1 11.9793 14.6347 10.4335 18.2405 9.923 28.253 +584 2 12.2756 14.1199 9.71871 15.2703 -21.0335 -29.0838 +585 2 11.0615 14.7405 10.2767 -32.5541 7.66631 -1.56623 +586 1 6.81522 6.956 15.5295 -17.6641 -14.7432 -7.98444 +587 2 7.71149 6.86909 15.2553 24.3623 -4.30517 -12.3513 +588 2 6.87971 7.6292 16.1782 -5.40685 18.4787 21.7047 +589 1 8.03389 4.5887 13.4155 -37.171 -3.64226 -22.5123 +590 2 7.25568 4.78495 12.82 23.9185 -7.87368 18.6792 +591 2 8.43341 5.43391 13.5743 6.319 9.72574 1.79505 +592 1 13.4002 12.1853 14.3374 -4.54681 1.91445 -1.84351 +593 2 13.053 11.3082 14.1695 -1.05297 -9.08012 2.89826 +594 2 13.8525 12.4201 13.5231 2.34057 5.70396 -2.70792 +595 1 14.6576 9.49709 7.25838 9.71531 18.8932 28.1379 +596 2 15.5128 9.94191 7.46983 -15.999 -8.53149 -8.43731 +597 2 14.0596 9.76702 7.98865 8.11873 -7.0154 -18.3951 +598 1 12.7312 16.9238 3.19475 21.2814 -46.1617 -18.4213 +599 2 12.8913 17.1254 4.09275 6.71284 11.8391 31.6773 +600 2 12.0991 17.5238 2.88672 -32.0955 36.7838 -15.6883 +601 1 1.05963 7.10571 17.4007 12.4792 -13.0695 22.2141 +602 2 0.186546 7.34268 17.7101 -8.13154 -6.52047 1.59159 +603 2 1.15324 7.46505 16.5336 -1.37945 14.6986 -20.6467 +604 1 12.8789 5.0234 15.6828 -31.729 4.63914 -0.239626 +605 2 13.551 4.37036 15.6981 25.2388 -22.1242 0.0408259 +606 2 13.353 5.8465 15.7229 6.14669 17.5754 0.411177 +607 1 2.40704 3.36861 5.12193 5.52974 -41.8871 -53.5671 +608 2 1.82145 3.26591 5.8288 -30.6852 -8.64892 41.0269 +609 2 2.78115 4.20498 5.20734 26.4804 50.2953 11.9131 +610 1 8.27515 11.124 13.5771 -2.85187 11.2881 -70.0801 +611 2 8.37295 10.8581 14.431 -1.92558 -15.2628 85.0569 +612 2 8.99363 10.6344 13.1748 6.72692 3.2721 -14.9 +613 1 12.918 1.48119 13.2724 -5.46048 -28.9446 23.2516 +614 2 13.637 1.39783 12.6661 14.6279 -0.945194 -20.1211 +615 2 12.6406 2.36931 13.1901 -10.8983 31.3672 -5.19186 +616 1 6.50945 13.6334 2.15016 9.54562 -3.73103 -23.7728 +617 2 5.85792 13.9589 2.75542 -11.9505 6.96003 17.098 +618 2 7.07728 13.0286 2.63475 0.813075 1.46302 3.43305 +619 1 15.9192 6.52891 12.704 16.1802 17.7634 -8.70325 +620 2 16.3422 7.10874 12.0232 -9.40583 -17.3352 17.4966 +621 2 16.4304 6.67694 13.5293 -11.6709 -4.5663 -12.9766 +622 1 16.8012 0.7168 9.58424 5.37965 28.6432 5.104 +623 2 16.9134 18.4317 9.69441 -4.13374 -28.9785 4.85106 +624 2 16.4797 0.860059 8.69243 -6.31121 -1.15561 -8.50241 +625 1 6.13999 11.6637 8.32406 3.84263 60.0529 3.8669 +626 2 5.34748 11.493 8.80779 -22.31 -6.18549 9.45125 +627 2 6.46273 10.8378 8.08078 19.7827 -51.2376 -16.1138 +628 1 2.82548 8.7059 0.356008 25.1404 7.14145 17.7175 +629 2 2.1872 8.20684 18.5458 -21.47 -27.2684 -27.7438 +630 2 2.28201 9.37487 0.754925 -1.41085 15.0233 10.6798 +631 1 10.1039 10.4509 6.57992 -4.79526 -6.25674 7.70278 +632 2 10.5083 9.74309 7.09516 2.94215 -0.723708 0.948173 +633 2 10.6276 10.5201 5.78606 4.97834 -0.717699 -12.6856 +634 1 6.77313 15.7547 6.63388 -5.578 -17.4503 -5.92282 +635 2 7.15743 16.0375 7.46176 7.11582 8.10879 3.23091 +636 2 7.28529 16.1142 5.89948 -1.84538 11.4125 4.1387 +637 1 6.44197 13.0281 5.69829 11.2984 8.90971 -1.05733 +638 2 6.79679 13.8886 5.97631 -5.91305 -5.55439 0.155281 +639 2 6.12445 12.6032 6.49753 -3.74834 -3.51916 3.00547 +640 1 16.7803 12.5246 9.7433 1.48678 16.9805 10.4147 +641 2 16.9869 12.0132 8.97443 1.49858 -19.0548 -12.8116 +642 2 17.3026 13.3224 9.61445 -4.02823 0.499055 5.20393 +643 1 6.14077 2.94238 2.79674 5.90568 12.9134 -1.15866 +644 2 6.37771 3.87334 2.54509 -6.86675 -27.0997 0.367621 +645 2 5.77601 2.45475 2.03942 1.6023 9.98348 0.439644 +646 1 10.8329 3.18005 3.24633 -5.48645 -3.34604 -3.46544 +647 2 10.1887 3.87164 3.40992 -1.49044 3.74393 4.82403 +648 2 10.5052 2.73309 2.45537 3.4248 -0.0323397 2.60803 +ITEM: TIMESTEP +60 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.78901 6.89398 17.9776 -3.5234 1.93788 3.89787 +2 2 7.91305 7.05712 18.3419 -1.4277 0.241332 2.63834 +3 2 8.67661 6.15674 17.3832 1.3639 -6.15529 -7.04239 +4 1 18.7561 8.31771 6.77309 10.5748 -7.50476 -33.4266 +5 2 0.457617 7.9886 5.89382 -17.7288 16.9324 23.762 +6 2 0.568724 7.76979 7.40723 1.86737 -7.24646 12.6232 +7 1 8.51532 18.7703 6.84705 0.662358 -5.68449 9.56329 +8 2 9.4329 0.211311 6.58737 4.53489 1.21926 -2.36791 +9 2 8.05203 0.803554 6.35578 -1.87482 6.91549 -4.54998 +10 1 6.50103 1.76445 11.707 -23.9337 -6.76257 7.94266 +11 2 5.68898 2.17855 12.0897 23.4576 -7.00878 -10.5629 +12 2 6.21872 0.874053 11.3985 3.54415 20.4784 6.13886 +13 1 7.00577 5.62696 2.40487 20.8008 -18.6778 -13.9491 +14 2 6.3381 5.93149 2.99593 -12.7158 11.2498 18.9927 +15 2 6.96044 6.19487 1.63998 -3.33571 5.44078 -9.1088 +16 1 16.2317 10.2379 16.0906 -2.65398 7.02849 4.45196 +17 2 17.1094 10.623 16.0697 3.52116 -7.47169 -6.62031 +18 2 15.6835 10.996 16.3292 -1.12895 -7.31017 -0.603728 +19 1 10.664 14.9341 2.30567 13.0251 3.56406 6.3158 +20 2 10.7336 14.2976 3.03428 -5.34804 6.23285 -3.50086 +21 2 11.2229 15.6743 2.58509 -4.07292 -1.48419 -0.585019 +22 1 17.1728 8.23947 10.7128 -1.64499 -1.99855 0.608593 +23 2 16.6728 8.84067 11.2819 0.316783 0.889357 -0.63917 +24 2 17.9322 8.74349 10.3965 1.71935 0.329185 -1.07247 +25 1 14.697 15.9473 16.4368 -13.7705 -0.197196 -7.11694 +26 2 13.7879 16.279 16.3001 13.6207 -4.8592 3.02749 +27 2 14.6438 15.4158 17.2461 5.07545 7.5417 -4.99128 +28 1 12.1134 13.367 0.528093 -6.39608 9.01831 -4.72995 +29 2 11.8173 13.4954 18.2644 6.74141 -8.66363 -5.87361 +30 2 11.5587 13.987 1.01769 3.38254 -3.71164 8.60635 +31 1 9.30318 5.47999 3.94883 35.8178 1.45581 -2.5285 +32 2 8.76671 5.2044 4.67379 -16.9173 -4.15595 18.9992 +33 2 8.71572 5.58687 3.21666 -20.2172 1.55363 -14.8227 +34 1 1.70529 4.08306 11.601 -3.00308 -9.11056 -2.97947 +35 2 1.52513 4.97184 11.9147 2.37337 9.05749 0.600173 +36 2 2.22567 3.63839 12.2786 -1.82607 -0.283286 1.9059 +37 1 2.04499 6.82744 8.26893 9.18028 14.0429 7.96475 +38 2 2.5896 7.29904 8.93262 -11.3816 -6.25496 -6.31442 +39 2 1.81536 5.98181 8.67357 4.33854 0.450625 -3.71013 +40 1 5.3656 4.4774 7.93824 1.44041 9.72132 7.59831 +41 2 5.44269 3.52851 7.84762 -1.19648 -12.0175 -6.62376 +42 2 4.92598 4.83778 7.16432 -9.0894 -3.97332 -7.9273 +43 1 3.32251 2.9413 17.4443 0.538374 -34.3486 -6.77872 +44 2 3.98642 3.24962 16.8336 8.9197 7.73227 -3.39959 +45 2 3.04976 3.68399 17.9526 -12.2781 23.4468 13.5982 +46 1 7.437 5.38423 6.13063 5.01567 -0.272219 -26.6536 +47 2 7.97737 5.94965 6.66546 10.8347 10.076 12.8667 +48 2 6.99068 4.78917 6.71033 -9.3836 -11.0864 17.8628 +49 1 9.80479 7.01238 12.0379 -9.46641 4.39554 -21.4508 +50 2 10.3276 6.40912 11.4906 -4.30802 3.34771 7.14548 +51 2 9.13044 7.38666 11.4225 10.4612 -8.54147 15.485 +52 1 14.0024 3.65677 8.07153 1.90613 10.1899 13.6881 +53 2 13.9361 4.48059 7.56554 -1.4656 -7.0627 2.39316 +54 2 14.1946 3.93561 8.9889 0.417494 -3.38136 -15.0381 +55 1 4.51888 17.1453 3.95588 7.87944 -4.67708 3.20643 +56 2 5.41436 17.4585 3.90856 16.3959 1.38908 8.05638 +57 2 4.13204 17.4705 3.15493 -16.1768 7.51082 -11.5461 +58 1 16.4506 16.6012 10.3314 -28.9812 -6.12917 4.01051 +59 2 15.5905 16.5574 10.8183 20.4446 2.48532 -11.9951 +60 2 16.2667 16.1387 9.49338 0.364513 2.67256 9.91326 +61 1 1.97065 4.79938 0.260671 -8.10245 -17.5737 -13.0373 +62 2 2.41281 5.12274 1.03667 10.218 10.6244 9.40508 +63 2 1.8267 5.54768 -0.321227 -3.59337 9.6389 -0.147197 +64 1 11.5035 13.2586 16.3577 -0.713967 20.2415 12.8794 +65 2 11.0441 12.4305 16.4814 -6.19498 -9.28579 -2.23027 +66 2 12.0754 13.1484 15.6021 5.65191 -4.41955 -9.63321 +67 1 10.1276 11.0105 16.8449 -6.46201 16.5427 1.83518 +68 2 10.5556 10.1721 16.794 12.0656 -22.7421 -1.13044 +69 2 9.20289 10.8171 16.6996 -9.212 1.56961 -0.130134 +70 1 11.787 17.4505 13.4822 -3.74088 11.88 -4.97071 +71 2 12.2373 16.9277 12.8063 6.56705 3.4706 4.72845 +72 2 12.0251 18.3805 13.3063 -1.30808 -7.68873 2.97322 +73 1 6.42132 9.37259 12.2366 13.1698 8.24141 3.19081 +74 2 6.99069 9.01867 11.5406 -12.3498 -0.982732 4.41902 +75 2 7.03807 9.88277 12.7853 -8.70879 -2.27031 0.0855326 +76 1 16.2815 12.8722 2.70224 -2.02351 7.50879 0.830271 +77 2 17.1172 13.3658 2.56775 -16.1548 -5.18742 1.80773 +78 2 15.5334 13.5108 2.69253 18.3367 -6.33955 1.64103 +79 1 0.729913 12.6587 5.89268 5.90957 5.27776 3.54404 +80 2 1.01336 12.4973 4.99287 4.32656 -0.558571 -7.43154 +81 2 18.4322 12.7877 5.81211 -15.2269 -3.44557 0.704235 +82 1 5.2582 16.4249 18.4194 -10.384 10.1199 -1.35479 +83 2 5.6864 15.6785 18.0038 6.48963 -9.24773 3.62069 +84 2 5.52942 16.4885 0.694307 6.00107 -3.50652 -0.438993 +85 1 0.618748 7.72132 4.16911 -57.0293 -28.7954 36.7096 +86 2 18.6577 8.06272 3.52122 -10.6934 7.30065 -13.2418 +87 2 1.44908 7.88182 3.83946 68.942 18.8036 -26.9673 +88 1 3.13476 8.97804 6.4725 9.50813 11.9402 -13.0637 +89 2 3.74054 8.49646 7.01761 11.8689 -6.06991 10.2621 +90 2 2.28514 8.86225 6.86989 -19.244 -2.30506 4.89646 +91 1 7.29998 10.3842 16.2581 17.8205 -0.109318 -17.8263 +92 2 6.62843 10.5749 15.608 -5.58859 2.04705 -1.34953 +93 2 6.87201 10.3756 17.1052 -6.43011 -2.48695 12.6131 +94 1 11.0863 0.954938 5.00203 0.851153 5.26347 3.05665 +95 2 11.191 1.83687 4.62341 -3.02583 0.75042 -0.451702 +96 2 10.8235 0.406956 4.25776 -2.05383 -4.79736 -1.16032 +97 1 4.33613 2.85707 13.1911 1.54519 27.1095 -5.33994 +98 2 4.57692 3.1724 14.0657 0.352889 6.79614 0.336856 +99 2 4.2364 1.93118 13.308 -7.70759 -34.1778 4.58716 +100 1 8.4203 10.2079 1.80876 2.06346 -1.14808 -20.454 +101 2 8.303 10.9031 2.4489 -3.41662 7.51624 10.9075 +102 2 8.71506 9.44854 2.30018 2.97787 -12.0816 9.03727 +103 1 10.3977 1.70625 15.5267 1.73644 2.79304 1.06494 +104 2 11.3647 1.6343 15.5026 -8.09264 -2.44943 -3.11689 +105 2 10.0867 1.93234 14.6348 6.55478 -0.658466 2.12488 +106 1 2.65181 12.9273 7.85805 -0.311785 2.06689 -1.07798 +107 2 3.23228 13.5447 7.39928 3.74905 0.741997 1.40009 +108 2 1.98379 12.6968 7.20259 -0.999427 -0.794231 1.07688 +109 1 3.77953 11.641 5.00453 4.18201 7.36008 7.19136 +110 2 3.61117 10.803 5.43181 -1.00449 -4.29555 7.12479 +111 2 2.98088 11.8656 4.52857 -4.84381 -0.0516249 -5.594 +112 1 6.70671 14.4383 16.9441 -2.88793 7.65462 4.66357 +113 2 7.46032 14.9632 17.2378 1.25427 -2.15328 -4.6823 +114 2 6.29331 14.8741 16.1864 7.83964 -2.53039 -3.71142 +115 1 14.1974 14.5272 3.32557 -8.64957 0.126228 1.77541 +116 2 13.6145 15.2324 2.99689 6.18241 -4.15847 9.95625 +117 2 13.7792 14.1343 4.11346 2.7139 4.36583 -10.9531 +118 1 8.49626 18.0895 16.0579 -56.9361 5.6973 -1.31016 +119 2 8.97799 17.2887 16.1101 31.3098 -20.0295 7.70991 +120 2 8.99116 0.248943 16.0582 28.7181 13.2998 -3.6499 +121 1 4.72072 1.70195 4.90499 9.17194 -24.9679 14.1726 +122 2 3.98364 2.22531 5.16555 -23.8501 10.7625 5.04957 +123 2 5.10611 2.17516 4.19081 15.0133 13.348 -19.3674 +124 1 15.0233 12.5839 16.4881 -18.3113 17.2758 -0.569629 +125 2 14.531 13.0978 17.1312 10.6463 -2.17552 11.3526 +126 2 14.3728 12.5238 15.7796 8.99848 -7.00837 -8.88439 +127 1 15.6995 18.4783 16.8755 -18.8856 10.9503 -24.4051 +128 2 16.4938 18.4127 17.3644 26.3461 0.942046 24.9737 +129 2 15.418 17.5728 16.7613 -4.49112 -11.2036 -1.17338 +130 1 1.28835 1.23059 16.5761 -5.93248 -0.138309 0.14802 +131 2 2.13994 1.64325 16.7078 7.79309 6.58334 -0.470261 +132 2 0.740967 1.66098 17.2372 -5.253 -1.12337 3.85618 +133 1 18.1629 4.44327 15.9115 -6.79632 -1.27318 -1.28488 +134 2 18.1308 3.86521 15.1462 0.0573414 -0.0912133 -1.44422 +135 2 0.437875 4.54116 16.1499 5.78898 1.89854 1.50737 +136 1 12.2373 17.0002 16.1546 0.545523 9.79929 -13.3931 +137 2 11.4461 16.6427 16.5433 -11.0844 -6.7728 9.10484 +138 2 12.011 17.1373 15.2222 3.0182 -2.09591 3.06353 +139 1 16.0678 2.55904 18.1722 10.2246 -6.29614 14.7907 +140 2 15.8342 3.46829 18.3235 -8.81825 14.1289 4.59946 +141 2 15.8732 2.39245 17.2622 -4.4601 -2.08833 -19.809 +142 1 6.72425 13.805 10.1648 -2.60578 6.66979 -6.33116 +143 2 6.49371 13.5045 11.0525 -0.564993 -6.25943 -2.37403 +144 2 6.44263 13.1457 9.51237 3.71898 -2.3263 8.04067 +145 1 10.1796 18.3897 2.72456 -2.84724 -9.82946 6.47371 +146 2 10.454 0.395639 2.08514 4.83004 8.04726 -9.16723 +147 2 9.37175 18.0281 2.35385 -6.15379 0.681222 3.71385 +148 1 3.03584 17.7169 6.12875 -8.09623 -9.32203 -7.45056 +149 2 2.18289 17.4189 5.74043 17.1828 11.6191 3.33552 +150 2 3.689 17.6882 5.40781 -11.2408 2.0569 5.59443 +151 1 12.6056 16.8615 7.96971 24.61 3.09247 -20.49 +152 2 12.0094 16.1192 7.91607 -18.906 -3.75998 3.49802 +153 2 12.4208 17.4479 8.69718 -9.87831 1.59818 13.2946 +154 1 14.8851 15.258 8.17849 4.86996 1.69705 3.53461 +155 2 13.9994 15.6489 8.25275 11.2692 6.96129 -5.86816 +156 2 15.346 15.6481 7.40987 -12.7499 -9.2219 7.50011 +157 1 17.7579 18.2305 0.335063 13.8809 -6.66068 -7.77561 +158 2 18.5388 17.6427 0.115787 -18.9695 29.962 7.44433 +159 2 18.0215 0.522838 0.460167 3.90753 -19.2563 -2.82208 +160 1 0.789759 10.4825 1.35847 3.51968 14.2812 -7.72333 +161 2 0.0798625 9.88631 1.6077 -6.45512 -1.46576 0.207918 +162 2 0.407025 11.2033 0.810215 7.48025 -15.8311 11.8414 +163 1 1.75759 12.251 3.36651 -3.2997 0.800224 -5.24767 +164 2 1.53389 11.5715 2.69671 0.947411 14.52 5.02147 +165 2 1.90006 13.112 2.93145 -3.03991 -14.1386 -4.6936 +166 1 0.626528 17.2392 4.94747 0.535799 -10.8391 4.53682 +167 2 18.8821 18.137 4.96158 -2.27873 -17.8214 11.6149 +168 2 0.354378 16.6324 5.68648 2.97307 28.5848 -17.7586 +169 1 1.10952 0.863641 9.39152 -13.7339 -4.40866 12.9037 +170 2 1.31873 0.587529 10.3088 -1.45288 2.90017 -16.0983 +171 2 0.209028 0.525909 9.24512 10.3392 4.25606 -0.349363 +172 1 16.7392 2.34887 13.3076 6.86896 9.31967 14.159 +173 2 16.9447 2.54868 12.3949 -1.60073 1.25233 -7.99088 +174 2 16.5723 1.40956 13.3727 -4.20045 -10.3799 -4.26178 +175 1 2.67499 15.8791 12.0838 -15.6649 13.6026 18.6328 +176 2 3.08767 15.4473 12.8331 1.25238 -1.62775 -1.314 +177 2 3.09072 15.5563 11.2931 8.09534 -6.35014 -12.1736 +178 1 16.4274 15.6453 6.10859 -17.0431 -16.804 0.948824 +179 2 17.3058 15.6768 6.44562 21.0308 -4.79075 10.9 +180 2 16.4023 16.3397 5.46924 -8.03031 15.1286 -15.2988 +181 1 5.80151 5.1106 11.8034 -9.99749 12.6805 7.50019 +182 2 5.41461 5.91177 12.2246 6.41162 -14.9692 -6.22456 +183 2 5.12172 4.42339 11.8362 4.25931 3.80702 2.95737 +184 1 15.1575 4.86793 0.802761 22.7174 4.42582 -27.0135 +185 2 14.9254 4.50834 1.64009 -5.31496 -5.26411 26.4075 +186 2 14.3858 5.30472 0.469017 -12.1413 5.82456 -3.82743 +187 1 16.3769 16.3844 2.01422 -5.72057 14.22 1.10565 +188 2 15.9278 16.7493 2.80314 10.8683 -6.01604 -9.24812 +189 2 16.773 17.1531 1.56448 -5.22082 -7.76197 3.40899 +190 1 0.23965 4.83003 3.84895 -16.8427 -30.7507 -16.2196 +191 2 0.252698 5.75131 3.99923 2.34384 38.0203 4.84997 +192 2 0.859131 4.45396 4.45569 14.7994 -7.19156 9.40612 +193 1 2.95205 15.0559 15.135 12.255 2.89982 -34.0079 +194 2 2.82691 14.77 16.0276 -6.33331 -2.96333 21.8089 +195 2 2.70057 15.9867 15.0833 -9.42631 -1.00353 7.2626 +196 1 1.12786 14.6523 9.50314 0.137917 -12.6668 4.07712 +197 2 1.90226 14.1941 9.14772 -4.18616 2.58129 -2.64264 +198 2 0.826039 14.044 10.1958 0.138103 8.11094 -6.03497 +199 1 13.5191 16.5585 11.5327 7.73147 -8.17374 8.97592 +200 2 13.1298 17.2703 11.0385 -2.21772 17.726 -8.86187 +201 2 13.0359 15.7976 11.2032 2.83922 -8.38127 -1.58332 +202 1 4.66669 1.44213 0.750789 16.1276 9.43437 -4.32571 +203 2 4.14083 2.03292 0.213208 -5.20243 5.56453 -6.36037 +204 2 4.0469 0.85314 1.17877 -1.04658 -3.40534 3.74731 +205 1 1.47829 18.5621 11.858 5.51121 1.25702 19.3245 +206 2 1.35114 0.550992 12.5892 2.53269 -8.70306 -5.34898 +207 2 2.06733 17.8728 12.2103 -6.7512 4.69931 -6.32602 +208 1 11.4685 10.1386 3.99675 -31.6511 -19.8648 40.1611 +209 2 11.3534 10.4173 3.11507 -1.88937 16.5167 -32.0622 +210 2 12.3922 10.1317 4.15588 31.92 0.339396 6.83567 +211 1 8.2329 12.185 3.6562 14.6677 -4.21505 -16.0366 +212 2 9.0609 12.5679 3.94713 7.11932 4.3628 2.52934 +213 2 7.63223 12.3212 4.36927 -17.6963 1.05811 24.4992 +214 1 14.5368 4.0151 3.29112 -13.123 -7.80297 -23.8392 +215 2 15.0981 3.94713 4.04639 13.729 3.5857 20.4451 +216 2 13.7669 4.51912 3.55347 -6.0046 4.6829 5.42155 +217 1 5.65486 1.65777 7.52148 58.4475 40.9395 -13.9317 +218 2 4.99661 1.25201 7.99959 -53.8788 -37.1346 38.2946 +219 2 5.51095 1.40377 6.61889 -5.49301 1.61126 -19.8188 +220 1 17.8901 1.045 4.84749 -9.94718 -16.9222 0.488244 +221 2 18.5122 1.52388 4.30334 5.34684 7.49098 -3.2278 +222 2 17.6047 1.57034 5.59464 4.63979 8.2364 3.24002 +223 1 6.81309 9.39039 4.50819 3.0131 -8.49785 6.19054 +224 2 6.80308 9.57416 5.46384 1.81054 -3.72037 -9.62081 +225 2 7.68859 9.02244 4.29465 -5.74329 4.97879 4.89484 +226 1 2.5752 14.8387 1.99973 -14.8295 0.871449 -1.75437 +227 2 3.26878 14.7632 2.65166 10.803 -1.54702 2.65568 +228 2 2.97003 14.8559 1.12279 1.99123 -2.02101 2.0261 +229 1 17.298 12.9204 13.1492 -3.4846 16.1956 -6.51124 +230 2 16.423 13.308 13.3278 8.68723 -6.18077 0.438899 +231 2 17.8438 13.7012 12.9334 -6.61166 -12.0077 2.21466 +232 1 14.9034 10.5534 1.40093 -1.35277 29.2651 19.5565 +233 2 15.388 11.3453 1.77149 -13.4573 -26.0533 -12.1606 +234 2 13.9634 10.6773 1.62965 16.0361 -2.08776 -5.28169 +235 1 5.72986 6.65162 4.58435 -17.0557 15.5593 -6.14164 +236 2 5.84842 7.61417 4.55049 3.33824 -4.32419 -0.681988 +237 2 6.28697 6.32726 5.29234 8.09232 -2.61709 -0.816212 +238 1 7.99944 8.35521 10.3848 17.9936 -2.63811 -6.27588 +239 2 8.59251 9.07404 10.0893 -6.48701 -11.154 -5.32581 +240 2 7.88909 7.71789 9.66296 -2.42609 11.6503 -0.200638 +241 1 13.4241 18.44 5.69275 23.5538 0.0525075 -9.71433 +242 2 12.6953 0.391603 5.53139 -12.0458 3.72648 -1.32391 +243 2 13.2482 18.017 6.52624 -8.74326 -11.7295 10.7578 +244 1 0.0158155 2.64508 0.27395 14.5716 -58.678 15.8132 +245 2 17.7841 2.79898 -0.0392974 -21.1138 14.4347 -10.6776 +246 2 0.56739 3.397 0.238244 13.7063 38.8805 -4.38724 +247 1 12.8888 11.0203 9.74081 14.4921 -25.5472 6.65601 +248 2 11.9442 11.0265 9.60333 -9.9467 -3.56544 -1.05488 +249 2 13.1018 10.1085 10.0646 -8.85698 19.3484 -7.35591 +250 1 0.676749 12.1402 11.0769 -15.7222 13.4662 19.3247 +251 2 18.361 12.1632 11.2371 5.51909 -2.16069 -8.49445 +252 2 1.03381 12.419 11.9274 8.68848 0.134808 -1.80861 +253 1 5.1281 7.32638 13.4074 12.574 7.81643 0.126088 +254 2 5.56178 8.11083 13.0117 -0.574951 -12.9077 2.36295 +255 2 5.67541 7.10745 14.1812 -7.25639 3.83801 -6.5213 +256 1 1.19691 6.83481 11.9192 5.63437 23.0857 0.0567084 +257 2 0.430704 7.22717 11.4609 12.0202 -4.44614 6.83847 +258 2 1.80476 7.59103 12.1282 -18.5438 -19.7012 -5.0003 +259 1 15.5112 9.6605 12.308 7.39931 -23.3592 2.14975 +260 2 15.3284 10.5626 12.1388 -11.1565 28.2269 -10.7029 +261 2 15.46 9.608 13.2546 2.72926 -7.26454 12.4411 +262 1 16.5981 12.7055 5.55132 5.93792 -6.99565 4.13948 +263 2 16.3871 13.6216 5.72312 -3.40713 11.8574 1.85996 +264 2 16.4508 12.5854 4.61105 -1.1211 0.407027 -8.19974 +265 1 6.341 9.80883 0.0188309 -5.87145 18.2236 11.3739 +266 2 5.58583 10.3592 0.271383 3.51693 -3.70717 1.01998 +267 2 6.97723 9.90576 0.746734 -2.19026 0.0209431 -7.09875 +268 1 12.2976 6.11648 4.05009 -7.99316 6.14403 -18.1211 +269 2 12.258 6.83685 3.38221 3.50754 -15.1435 11.6411 +270 2 11.4736 5.62673 3.91242 4.22123 1.1153 4.56647 +271 1 0.341758 12.8367 0.152932 -4.41368 -4.71323 -6.18075 +272 2 -0.071293 13.3938 0.818389 4.38543 6.64898 2.3316 +273 2 18.4831 12.9746 17.9873 -4.56942 3.87447 -1.94524 +274 1 3.61813 18.6313 8.61443 0.661139 8.76689 2.03667 +275 2 3.46056 18.3752 7.69711 -0.554223 -6.30588 2.24303 +276 2 2.77043 0.354615 8.90695 5.13325 -4.08936 -2.3138 +277 1 7.42355 17.3409 4.4768 -7.56741 1.42105 -0.716546 +278 2 7.51902 18.2689 4.68925 3.30463 5.13228 6.51734 +279 2 7.58206 17.32 3.5353 -0.521854 -4.80047 -8.50069 +280 1 9.24832 17.1301 12.2139 -13.1815 7.8308 -4.22869 +281 2 9.33905 16.301 11.7591 -2.0028 -14.1862 -9.75618 +282 2 10.0447 17.2202 12.718 16.3553 3.99578 13.5609 +283 1 13.2894 13.0415 8.03267 8.35671 10.0486 -9.41069 +284 2 13.3695 12.1786 8.4589 5.84428 6.69767 4.94138 +285 2 14.1604 13.5085 8.0433 -18.6948 -10.3528 3.9365 +286 1 14.8481 2.99092 15.3927 0.856118 4.40098 19.7153 +287 2 14.1706 2.3196 15.3374 -5.14829 -8.82459 -5.54141 +288 2 15.3789 2.92995 14.603 5.00888 -0.952448 -11.2281 +289 1 9.90287 15.5907 16.9887 3.86064 7.54266 0.708681 +290 2 10.4376 14.8321 16.7196 -3.05759 -5.14225 0.11478 +291 2 9.69704 15.4836 17.9287 -2.19155 -3.5869 -5.21272 +292 1 11.3068 8.44228 16.6046 -8.18504 -5.87812 -2.49231 +293 2 10.7375 7.86962 16.0559 4.371 7.7216 8.33293 +294 2 11.2933 8.06373 17.4959 1.16379 -1.60832 -8.83864 +295 1 4.00007 18.2264 16.7774 4.24494 10.2639 17.5421 +296 2 4.56172 17.6396 17.2965 -1.57319 -6.32646 -5.9019 +297 2 3.85664 0.302165 17.4089 -1.12143 -0.586814 -11.7526 +298 1 2.2479 4.22742 8.91978 -15.7964 -0.236851 -9.315 +299 2 3.17417 4.26053 8.71033 14.3134 -0.385935 -1.23962 +300 2 2.16897 4.01078 9.84529 1.80454 -0.809508 12.1296 +301 1 9.87751 10.3883 9.74788 10.9603 -30.3507 -6.41167 +302 2 9.55849 11.2198 9.44401 -12.062 25.9436 -6.06801 +303 2 10.0779 10.4258 10.6774 1.92757 5.46095 17.7276 +304 1 9.69765 0.927205 10.8701 14.9831 -0.992619 -3.75191 +305 2 9.43595 0.039964 11.1566 -10.0783 4.56951 -4.94264 +306 2 9.12787 1.25731 10.1583 -1.53115 -8.98556 4.28196 +307 1 9.19006 15.088 10.2066 22.8811 13.4843 7.03893 +308 2 8.82905 15.9231 9.90375 -5.23887 5.212 -7.88342 +309 2 8.4517 14.4971 10.2333 -16.9878 -12.2258 -0.936878 +310 1 0.910091 9.64474 10.2618 6.35784 -25.2235 -17.0921 +311 2 0.848571 10.4636 10.7331 2.68282 16.4495 1.28733 +312 2 1.6853 9.71195 9.67503 -11.8234 -0.16557 12.5577 +313 1 17.0493 4.85425 8.1315 23.124 -12.0189 -22.071 +314 2 16.5036 5.57379 8.38464 -19.6085 19.0848 9.20549 +315 2 17.0051 4.2127 8.82658 -1.69519 -7.20825 12.6053 +316 1 14.7684 14.7087 0.123438 -2.69691 -12.5371 -11.3918 +317 2 15.061 15.3506 0.758659 10.1685 10.0196 13.4831 +318 2 13.9556 14.337 0.462955 -8.28455 -4.39651 5.72223 +319 1 3.75153 11.0481 9.53582 4.71209 -10.2499 1.98044 +320 2 3.63189 11.3357 10.4456 -0.734234 5.70871 5.17654 +321 2 3.24354 11.632 8.96907 -2.43681 8.8531 -2.47663 +322 1 11.2519 10.7463 1.5017 8.48932 -12.5201 -0.266865 +323 2 11.5908 11.5519 1.12329 1.64528 14.0457 -7.10687 +324 2 10.3311 10.688 1.26079 -12.3399 1.77059 -3.9568 +325 1 13.1496 7.17281 12.6854 5.50111 -7.8338 2.87732 +326 2 14.101 6.95885 12.7444 -10.2033 1.82309 -0.47089 +327 2 12.6663 6.34751 12.851 5.63542 3.55 -1.50526 +328 1 9.61828 1.90104 0.967862 -1.73511 6.80555 -16.7575 +329 2 8.75126 1.82608 0.511852 18.7109 -2.38487 5.6602 +330 2 10.2637 2.29933 0.349253 -13.3131 -4.11214 4.99441 +331 1 10.6435 13.4896 4.54607 -8.3754 1.2658 -1.96254 +332 2 11.4795 13.0515 4.69791 8.28938 -6.58305 0.731496 +333 2 10.5798 14.1432 5.24738 -1.32643 -0.553656 5.74704 +334 1 14.4543 1.71115 10.9546 -7.69161 -4.81009 -3.91494 +335 2 15.2136 1.28396 10.5547 4.80162 -2.13195 -1.67599 +336 2 14.6015 2.65135 10.8079 -1.60778 0.935868 6.54178 +337 1 14.5384 12.1186 11.6682 4.42158 0.0609916 50.1985 +338 2 15.3244 12.3738 11.2188 19.3883 10.0258 -22.7848 +339 2 13.838 12.0043 11.0592 -19.2299 -5.1918 -28.9193 +340 1 8.19636 5.07775 9.81895 6.92668 -2.08004 -5.22277 +341 2 7.38544 5.24812 10.3055 -3.33886 -3.05544 1.61921 +342 2 8.19204 4.12852 9.59915 -2.53054 10.0553 1.98192 +343 1 1.48663 16.8897 18.439 7.38955 -7.44055 -8.00122 +344 2 1.97341 17.2271 17.6702 -6.10601 -1.16576 3.12224 +345 2 1.43805 15.9298 18.2902 4.85843 10.0488 4.15854 +346 1 1.49392 17.3013 15.324 -13.7543 10.7593 4.06087 +347 2 1.44447 18.24 15.6259 -3.67575 -24.1287 -4.86768 +348 2 0.590882 16.9129 15.3122 14.6177 13.551 2.26757 +349 1 3.61646 5.75696 6.06482 3.05275 -16.2413 -2.75756 +350 2 3.17 6.32551 6.68313 -10.4039 6.81614 9.87761 +351 2 4.1613 6.3181 5.51248 5.12466 2.54076 -5.58469 +352 1 12.4579 9.47416 14.2028 -15.1686 39.1263 4.59508 +353 2 12.91 8.74193 13.8564 21.0065 -34.4741 -21.4004 +354 2 12.311 9.21984 15.1046 -5.21536 -3.05923 17.073 +355 1 4.05954 15.2722 6.9713 -12.2847 -13.6907 9.03639 +356 2 3.52733 16.0267 6.71946 -3.69787 8.1984 -1.38185 +357 2 4.94462 15.4979 6.70957 17.3953 3.39893 0.124931 +358 1 0.676716 8.64845 15.0435 0.0448789 -8.8726 2.29819 +359 2 0.388517 9.55355 15.1457 -0.102902 11.258 0.0552156 +360 2 1.38121 8.67263 14.3922 3.78483 -0.0353447 -4.44966 +361 1 12.9131 8.29224 10.2146 2.07907 -10.3878 2.68575 +362 2 13.6346 7.78925 9.80195 -2.79275 5.95566 3.91371 +363 2 12.8029 7.87463 11.0885 3.60602 9.09063 -7.955 +364 1 15.3505 7.77425 3.51602 -25.105 2.18251 -0.815364 +365 2 14.4666 7.51634 3.2857 -7.66712 2.41401 -31.383 +366 2 15.2516 7.5997 4.43625 29.5189 -3.75051 28.1293 +367 1 17.2908 6.71242 0.0288264 8.4359 -0.0595562 3.38218 +368 2 16.7481 6.02838 0.414195 -4.41494 -10.5616 1.77026 +369 2 16.6696 7.39667 18.4317 -9.71571 9.06541 -4.14994 +370 1 8.93558 6.94317 7.77066 11.3734 11.9101 1.30985 +371 2 9.8513 7.28708 7.82315 -13.5624 -4.9569 -0.419932 +372 2 8.83457 6.3282 8.49913 -0.351333 -9.82053 6.39411 +373 1 12.3886 0.605922 1.26733 4.3474 1.63423 -5.64369 +374 2 13.3496 0.62067 1.39833 -3.50709 5.26207 -1.10414 +375 2 12.2365 0.554465 0.317002 3.44844 -5.08055 2.164 +376 1 5.6093 15.1332 14.5298 5.50237 -6.63524 -3.85361 +377 2 4.67729 15.3131 14.6547 -7.5977 -3.56809 4.17708 +378 2 5.99198 15.9265 14.1501 5.33744 7.17763 0.920224 +379 1 3.83862 6.42399 1.72255 -0.530245 0.761181 6.81888 +380 2 3.42185 7.23588 1.41886 -3.5948 7.2146 -3.68667 +381 2 3.94102 6.55655 2.67261 0.00170673 0.796504 -2.59346 +382 1 3.90756 11.5263 12.3817 0.20855 -7.47029 -8.65749 +383 2 4.79535 11.8927 12.4625 -0.681042 -1.53834 0.918823 +384 2 3.33577 12.1179 12.8713 -4.93373 1.57702 0.731635 +385 1 5.31593 3.88159 15.8542 -0.71358 -42.6288 -12.177 +386 2 5.97198 3.22378 15.5406 -6.31298 7.40988 7.32158 +387 2 5.73536 4.71214 15.7787 14.3185 32.9857 -0.935745 +388 1 14.2562 10.2258 4.56557 -18.8652 24.4894 6.04548 +389 2 14.4389 9.92543 5.45169 -1.13053 -5.88778 11.8213 +390 2 14.6954 9.63367 3.98806 17.1426 -20.2086 -20.2139 +391 1 7.6892 17.381 9.10447 19.4711 -25.2283 0.682627 +392 2 6.86971 17.6207 9.51632 -14.1206 10.5396 4.24559 +393 2 7.90224 17.9622 8.37374 -3.5427 12.2774 -4.18627 +394 1 4.51373 14.5018 3.89084 0.522587 -13.0056 -37.966 +395 2 4.5996 15.4052 4.14706 0.258928 20.2029 10.6105 +396 2 4.49773 13.963 4.65868 1.58881 -14.8294 26.2191 +397 1 14.2556 7.39762 15.8429 -9.24001 -8.17606 -10.1746 +398 2 15.1854 7.31956 15.6389 10.3704 -1.38951 -4.38862 +399 2 14.2355 7.83779 16.6857 -0.295639 4.56275 12.5602 +400 1 3.05453 18.3862 1.94671 -28.337 -27.777 -22.0693 +401 2 2.58101 17.7651 1.32015 15.7039 17.8808 20.6311 +402 2 2.35293 0.259745 2.36363 3.01847 1.93426 2.5363 +403 1 7.98344 1.63895 4.58298 -1.95289 -5.65456 5.83277 +404 2 7.39472 2.00993 3.91227 5.60846 -0.877805 -3.34347 +405 2 8.83104 1.39808 4.18815 -5.23209 5.3786 -4.6966 +406 1 2.44155 14.16 17.683 19.8901 20.6744 -11.1998 +407 2 1.71949 13.6284 17.9614 -19.7639 -16.6874 11.6615 +408 2 3.22651 13.6749 17.9404 10.3416 -4.56611 4.09925 +409 1 0.874431 1.8172 13.9017 -2.66591 2.98819 0.0720706 +410 2 0.796895 1.67216 14.8604 0.805718 -0.9226 -9.7327 +411 2 18.6311 1.96655 13.5402 2.6832 0.103556 9.2189 +412 1 4.40474 18.7103 13.8903 -4.51489 2.73844 -3.11833 +413 2 5.26066 18.332 13.6843 10.2731 -0.629088 3.90858 +414 2 4.27285 18.5624 14.8326 -2.10334 -1.04281 2.89108 +415 1 7.22541 0.768378 18.3802 -7.41292 5.22253 -10.0414 +416 2 7.14919 0.357851 17.5011 6.06274 3.8916 10.097 +417 2 6.39657 1.25171 18.5223 1.70256 -10.1891 2.75464 +418 1 16.0038 18.3833 13.9769 4.60778 -2.90009 -16.1733 +419 2 15.0678 18.3553 13.7682 -2.12799 2.80836 4.60244 +420 2 16.1189 18.6995 14.8699 -6.8859 -1.5785 15.9997 +421 1 10.1619 4.59436 16.2508 34.7775 -10.6887 1.26028 +422 2 11.1678 4.58362 16.2281 -36.3206 4.79489 -1.20103 +423 2 9.8959 3.67942 16.0718 3.3051 4.94693 0.644026 +424 1 15.9268 17.7185 4.48585 -0.443376 -19.9814 -7.77196 +425 2 16.5546 -0.221465 4.56619 12.2284 16.6263 -2.03126 +426 2 15.0862 18.0786 4.73637 -15.899 7.019 6.15678 +427 1 6.9987 17.4508 13.864 -28.5259 -4.03497 -9.84039 +428 2 7.52153 17.7102 14.6061 10.1765 7.77338 18.9538 +429 2 7.63162 17.2858 13.1766 11.9873 -1.11294 -13.1093 +430 1 13.256 6.47431 6.57718 13.0919 -2.27803 2.33044 +431 2 14.2181 6.68617 6.52776 -23.2683 -1.75779 -6.09518 +432 2 12.9031 6.34478 5.6793 8.47748 2.51219 6.97161 +433 1 7.82324 2.30197 9.35649 6.58131 4.23212 14.3466 +434 2 7.32826 2.17284 10.185 -1.16662 2.6949 -8.43976 +435 2 7.24342 2.0875 8.62812 -8.03625 -5.88123 -5.84644 +436 1 15.1686 14.8419 13.6961 6.6084 -8.9126 -6.67367 +437 2 14.8499 15.0658 14.5674 -3.29174 5.55862 10.3748 +438 2 14.9102 15.5355 13.091 -7.311 3.85237 -1.87114 +439 1 9.39203 8.3247 3.79765 -11.0731 4.19637 -5.3616 +440 2 10.2213 8.76913 3.95172 10.5135 8.75123 3.89829 +441 2 9.56922 7.39926 3.9554 -1.92777 -9.54221 1.11885 +442 1 17.7628 13.6056 16.4368 0.454101 -14.0132 9.10192 +443 2 16.8123 13.4442 16.4542 -1.43638 -1.23592 -2.30674 +444 2 17.8812 14.4042 15.9249 -1.89469 7.90276 -3.85648 +445 1 4.90818 10.546 2.83916 0.136377 -2.73925 -10.4847 +446 2 5.60998 10.1288 3.34488 4.96678 -0.616571 0.115447 +447 2 4.51664 11.1769 3.44738 0.912314 1.46625 2.09919 +448 1 3.71104 8.38719 10.068 0.753133 0.0228827 -3.76935 +449 2 3.89927 9.29887 9.80067 -2.70003 -3.09285 3.15772 +450 2 3.67512 8.396 11.0298 -2.24059 1.87779 0.37074 +451 1 15.9565 6.94095 5.99865 -8.76526 9.77307 4.96327 +452 2 16.7516 7.41234 6.24421 7.68049 3.9133 2.85915 +453 2 16.2393 6.06165 5.75492 3.70751 -7.34759 -2.0072 +454 1 15.1339 7.14501 9.07066 -1.17949 -23.8082 27.0602 +455 2 15.8283 7.58235 9.55517 11.4438 5.0236 10.3868 +456 2 15.1116 7.57875 8.25013 -4.20744 20.1878 -38.3409 +457 1 6.25297 12.9267 12.7452 -4.72449 1.01458 -5.57239 +458 2 6.98991 12.3599 12.9819 6.62509 -1.61272 7.49964 +459 2 6.12032 13.5727 13.4468 2.47956 2.45399 3.39123 +460 1 12.1116 4.51066 13.1059 -15.4407 -10.6836 -10.9314 +461 2 12.4271 4.59486 14.0171 -10.4637 -2.65404 1.19035 +462 2 11.2547 4.00523 13.0473 26.1752 13.1928 8.83048 +463 1 11.3958 8.13336 7.91828 -4.43196 -2.05658 -14.2843 +464 2 11.9753 7.54394 7.4184 3.39578 1.92795 -0.521112 +465 2 11.8257 8.23937 8.76441 1.22007 0.905858 11.3028 +466 1 17.1296 10.8754 7.54699 -15.2323 -0.655909 3.97588 +467 2 17.811 10.2663 7.31344 17.8297 -18.4071 -0.448075 +468 2 16.9935 11.379 6.74844 -4.7697 12.6356 -6.62113 +469 1 5.29547 18.1363 10.9421 18.5805 -0.935137 -5.10578 +470 2 4.88577 17.8485 11.7431 -9.76906 -7.6723 14.1577 +471 2 4.62403 18.0611 10.2783 -13.9129 1.88822 -17.2145 +472 1 7.59234 17.5076 1.75687 4.86523 1.07577 -14.9702 +473 2 8.00304 16.7666 1.28453 -8.52174 0.253094 2.89961 +474 2 7.35564 18.1425 1.05706 3.89665 -2.44167 8.83688 +475 1 1.92302 12.8778 13.5789 2.91886 3.94981 -7.24471 +476 2 1.45818 12.4106 14.2651 -5.47786 -10.2367 6.99308 +477 2 2.33812 13.6191 14.0211 -0.459782 9.91978 4.14062 +478 1 9.50973 6.75636 14.7983 0.267759 -13.8501 3.13598 +479 2 9.76861 5.87974 15.1842 -3.78976 20.025 -16.8859 +480 2 9.67323 6.78366 13.8359 6.07296 -1.5477 12.5306 +481 1 15.3007 4.25662 10.7816 1.6835 6.93604 -0.852744 +482 2 16.2201 3.94716 10.8841 -13.758 11.9338 1.00514 +483 2 15.2044 5.07319 11.3041 5.68258 -12.2185 -1.66994 +484 1 11.2682 6.20917 0.148653 5.11845 2.03204 -0.614283 +485 2 11.4613 5.3156 18.5351 10.8417 -13.6045 -1.35957 +486 2 10.3344 6.26425 -0.02153 -13.2524 10.0913 1.35666 +487 1 -0.0515508 11.3921 15.0043 28.8186 -12.3739 35.7691 +488 2 18.1888 11.7008 14.2289 -27.1505 12.4881 -39.8426 +489 2 -0.144753 12.1488 15.5889 -3.39882 3.34168 7.51926 +490 1 7.01363 9.26741 7.30523 1.11866 9.50703 -8.15996 +491 2 6.64493 8.42979 7.58084 -4.10674 -7.85165 7.60391 +492 2 7.94964 9.11568 7.16987 5.72986 -2.82238 2.51511 +493 1 18.3266 15.3189 12.3109 1.98396 7.8422 -1.62162 +494 2 0.557814 15.686 12.1521 7.34904 -2.57966 -0.481227 +495 2 17.7488 15.821 11.7275 -2.3238 -0.409324 -3.46342 +496 1 16.5074 4.41847 5.29023 -12.2776 2.5176 -39.1335 +497 2 16.8214 4.00292 6.06235 10.453 -12.003 36.2431 +498 2 17.1989 4.29433 4.62557 3.70164 8.40848 3.22117 +499 1 17.7062 3.18115 10.7633 -10.0415 -0.498888 0.968384 +500 2 18.5829 3.451 11.0307 13.8857 -2.29821 0.377097 +501 2 17.7544 2.33603 10.3089 5.51555 -4.87272 -1.50428 +502 1 12.31 -0.0249004 10.0958 7.06597 -29.3992 -7.90418 +503 2 11.4091 0.228435 10.2265 -21.0592 11.9526 6.39906 +504 2 12.8361 0.735194 10.2786 15.1995 22.0824 4.66414 +505 1 10.3672 9.76964 12.4555 1.27225 -3.68083 -7.54967 +506 2 11.1341 9.82258 13.035 0.839453 -0.704743 2.83749 +507 2 10.2702 8.82174 12.2801 -0.554943 5.543 3.04928 +508 1 0.65465 2.77798 7.04528 -2.13863 -3.2199 7.00126 +509 2 0.891211 3.42266 7.72053 -0.0150652 2.55779 -0.825415 +510 2 0.990123 1.95336 7.40694 -1.54003 -2.33595 0.508806 +511 1 0.295674 15.3348 6.84982 -3.22172 27.5014 26.3495 +512 2 0.521244 15.1551 7.76985 -0.748412 3.60522 3.47657 +513 2 0.484365 14.5358 6.4159 11.6769 -37.1534 -21.5269 +514 1 17.0573 6.99129 15.1128 -10.0859 0.519269 -2.81001 +515 2 17.7626 7.64158 14.9811 2.36054 -7.88383 3.70046 +516 2 17.4128 6.20418 15.5441 6.5971 2.49163 -1.29874 +517 1 9.10445 12.4501 8.04005 25.0355 12.8023 20.768 +518 2 9.46092 11.7782 7.45434 -7.91968 -3.65307 -8.74082 +519 2 8.16829 12.5393 7.95206 -19.3694 -6.70788 -7.44718 +520 1 1.22811 1.76814 2.9182 -6.11732 -10.0295 -0.237983 +521 2 0.712195 2.08081 2.16479 2.12402 6.69579 0.750032 +522 2 1.58605 2.52034 3.3947 3.99278 5.86411 -0.360805 +523 1 4.10894 15.0956 9.93451 6.69744 -1.75099 -1.18621 +524 2 3.96901 15.3261 9.00671 4.91376 -1.44666 0.188494 +525 2 5.04659 14.871 10.0423 -6.23862 1.0691 -5.37016 +526 1 7.35274 2.18983 14.6875 -7.358 8.13743 -4.11606 +527 2 7.08638 1.65776 13.9297 0.32385 -1.91134 2.32143 +528 2 7.57979 3.04743 14.3014 5.83731 -4.25907 3.58957 +529 1 18.4915 14.5922 2.16266 -14.7631 20.4811 3.31696 +530 2 0.685462 15.0501 2.31645 0.801171 -7.89169 -2.84158 +531 2 17.8141 15.3012 2.20781 8.07106 -12.7893 -1.48401 +532 1 9.99475 2.73128 12.8993 -0.14498 6.34622 4.34107 +533 2 9.94968 2.10764 12.1674 -2.02697 0.25981 -1.25528 +534 2 9.23805 3.32791 12.8055 1.37719 -5.85529 0.104676 +535 1 2.96937 8.88969 13.0348 8.45161 15.4602 -1.6792 +536 2 3.19044 9.8379 12.866 -0.537566 -21.2484 3.2835 +537 2 3.7799 8.47356 13.3849 -14.589 3.50084 -4.12479 +538 1 3.21 8.56161 3.75492 -0.42537 -8.47878 -37.7314 +539 2 3.66747 9.30861 3.32521 -2.76458 -7.90594 7.43156 +540 2 3.22415 8.6869 4.6856 3.07128 8.62247 25.8231 +541 1 5.62342 7.20688 8.60781 8.60088 8.53717 -11.0276 +542 2 5.53536 6.26871 8.41561 -2.891 -1.4677 7.62716 +543 2 4.92494 7.48858 9.21156 2.86443 -6.54236 0.635755 +544 1 14.9008 1.47426 1.89198 -2.54888 27.9205 4.61998 +545 2 14.5535 2.29499 2.28075 -2.57285 -15.9361 9.92214 +546 2 15.4844 1.8547 1.23467 3.18874 -15.0862 -12.382 +547 1 8.48736 15.1158 0.783841 -1.15568 2.93173 4.22404 +548 2 9.1238 15.1934 1.5071 4.62293 -5.62872 -5.40551 +549 2 7.79285 14.5509 1.14844 -2.73481 2.50701 -2.31707 +550 1 15.539 1.37952 7.19688 19.4515 3.6409 9.83231 +551 2 14.9389 0.78101 6.7773 -13.8468 -10.3512 -10.8641 +552 2 15.0003 2.07296 7.57775 -6.55979 11.3773 -1.03994 +553 1 5.01034 12.9912 18.4705 -11.9235 -4.12885 0.570622 +554 2 5.4698 12.9987 0.669061 0.312037 0.832023 7.43214 +555 2 5.59011 13.4721 17.8825 4.88062 -0.262691 -5.03625 +556 1 15.3764 8.57785 18.0866 -6.62354 -11.676 10.0569 +557 2 15.6805 9.14973 17.3909 9.52323 10.3388 -11.2321 +558 2 15.2475 9.1488 0.206008 -1.03261 3.33477 1.75561 +559 1 12.066 3.08414 18.3349 -10.3405 10.2428 -1.58162 +560 2 12.3601 2.47993 0.38654 4.70786 -1.39849 -7.75748 +561 2 12.2507 2.72995 17.4495 4.61736 -8.1861 15.8047 +562 1 13.1968 12.6883 5.15757 -0.336282 2.96846 2.60586 +563 2 13.7743 11.9999 4.79412 -5.71366 -0.326721 6.52296 +564 2 13.1697 12.5812 6.12031 6.45904 1.498 -4.43193 +565 1 6.0986 7.21596 0.138974 -12.0498 11.3036 0.237585 +566 2 5.91833 8.16028 -0.0709607 9.65884 -21.2748 10.0237 +567 2 5.34258 6.95155 0.690129 5.85049 -3.44248 -7.26534 +568 1 17.7044 15.8891 14.9714 -7.43083 8.66678 -26.2685 +569 2 16.7907 16.1885 14.8618 6.06094 -1.91119 12.6189 +570 2 17.95 15.7638 14.036 5.46338 -3.82161 12.7361 +571 1 13.1509 0.939295 16.6327 -8.19033 8.72571 -1.54201 +572 2 14.0859 0.833936 16.7968 10.9207 -0.957234 5.29932 +573 2 12.8431 0.0418051 16.5014 -5.83506 -5.32332 -1.35137 +574 1 10.9522 14.5534 7.35938 -9.11436 -19.3925 22.6665 +575 2 10.1531 14.2304 7.85485 20.6615 9.00594 -18.4516 +576 2 11.6365 13.8859 7.56325 -5.91964 10.2955 -7.71128 +577 1 17.5919 8.49388 2.10024 -0.0322199 -9.95032 2.76416 +578 2 16.7206 8.43914 2.53345 10.0393 -1.69965 -6.58888 +579 2 17.6862 7.68098 1.5623 -5.40062 15.1321 4.16518 +580 1 12.403 7.83298 1.98454 10.1699 2.43182 8.97059 +581 2 11.823 8.58837 2.10452 -0.914469 2.41145 -5.63632 +582 2 12.0432 7.27751 1.28772 -5.41827 0.0907324 -1.12401 +583 1 12.0169 14.6214 10.4613 22.6496 -4.80377 11.9203 +584 2 12.2953 14.2566 9.62296 -0.627137 -3.48742 -6.53871 +585 2 11.0904 14.7922 10.4232 -26.4922 1.86569 -7.97999 +586 1 6.79945 6.92747 15.5042 -19.94 -13.6896 0.562857 +587 2 7.71181 6.85747 15.2524 19.187 5.43316 -2.40109 +588 2 6.75196 7.52139 16.2502 2.78602 4.81827 4.32857 +589 1 8.02489 4.54706 13.3799 -9.17747 17.7449 0.879178 +590 2 7.13549 4.71954 13.0119 14.9133 -0.721221 -4.30494 +591 2 8.45659 5.41872 13.4818 -10.582 -17.269 -1.29002 +592 1 13.3893 12.1928 14.3557 -6.07818 9.44403 7.21842 +593 2 12.9754 11.3343 14.2402 3.84433 -8.34325 -3.30791 +594 2 13.789 12.4346 13.5154 0.839467 -1.50598 -4.68274 +595 1 14.6037 9.51924 7.26293 11.3016 8.32374 8.02904 +596 2 15.4883 9.92697 7.3747 -13.533 -2.89904 3.77438 +597 2 14.03 9.85877 7.96896 6.22863 -2.20078 -8.30261 +598 1 12.724 16.8794 3.24165 4.36843 -29.0517 -11.6906 +599 2 12.9143 17.2056 4.10583 4.58985 8.72699 22.0136 +600 2 12.2764 17.5776 2.79705 -13.1015 20.2627 -13.4405 +601 1 1.027 7.08618 17.3856 17.8688 -9.35062 9.83545 +602 2 0.150845 7.20834 17.7372 -11.0357 -5.72224 6.2597 +603 2 1.04228 7.56687 16.5674 -0.430665 10.2682 -15.3686 +604 1 12.9047 4.96423 15.6783 -31.9319 9.90183 -0.420667 +605 2 13.6101 4.38571 15.8945 27.3027 -16.194 0.870052 +606 2 13.2534 5.85423 15.7473 6.89498 8.57473 1.28829 +607 1 2.36359 3.37095 5.13131 13.5367 -21.0772 -51.8355 +608 2 1.78827 3.18983 5.83511 -26.0337 -9.2034 36.1161 +609 2 2.76982 4.19309 5.31063 16.9607 33.0577 11.3338 +610 1 8.25673 11.0457 13.6214 -29.0742 18.4766 -42.051 +611 2 8.3505 10.9269 14.5387 12.3752 -9.07103 37.7912 +612 2 9.04494 10.7715 13.1556 11.3248 -9.59576 5.23465 +613 1 12.933 1.51857 13.2538 -7.42773 -10.5209 16.1392 +614 2 13.555 1.47666 12.536 9.8649 3.44918 -12.9241 +615 2 12.6435 2.43109 13.2999 -2.22529 4.34734 -4.74481 +616 1 6.5593 13.6321 2.14465 -6.91915 6.53865 -12.6846 +617 2 5.89828 13.9136 2.78341 -2.94652 3.12599 2.20918 +618 2 7.14809 13.061 2.63026 6.2374 -5.23981 3.14213 +619 1 15.8933 6.50668 12.6624 16.2584 4.45316 -6.00807 +620 2 16.3963 7.03445 12.007 -8.38894 -8.88658 12.5353 +621 2 16.4415 6.50555 13.4748 -12.028 3.27562 -10.9527 +622 1 16.7983 0.717045 9.56947 3.68169 11.9749 4.12436 +623 2 16.6133 18.4601 9.81273 2.15246 -18.3954 6.85595 +624 2 16.3759 0.833391 8.71872 -3.66349 3.7587 -11.8412 +625 1 6.14397 11.6556 8.30338 8.0817 56.4015 -2.32443 +626 2 5.40727 11.3941 8.82366 -25.1595 -10.6153 12.4164 +627 2 6.54205 10.8782 7.99323 17.2725 -41.4748 -11.5815 +628 1 2.81032 8.69956 0.356218 24.742 -6.25 8.21391 +629 2 2.27105 8.19016 18.4013 -14.5977 -1.17978 -6.66412 +630 2 2.29881 9.42159 0.72289 -11.078 1.63045 0.198871 +631 1 10.1064 10.4292 6.59515 -4.60438 -3.93729 0.830471 +632 2 10.5227 9.70923 7.07758 4.69601 -3.0134 2.20114 +633 2 10.434 10.3774 5.69507 4.10481 0.747976 -4.90006 +634 1 6.80466 15.7541 6.67201 6.06476 3.31695 -2.74514 +635 2 7.12474 16.199 7.46137 -2.48244 -3.95514 6.52968 +636 2 7.21004 16.2686 5.96286 -5.79252 -2.21211 -4.39766 +637 1 6.45958 12.986 5.74076 6.97467 7.4921 0.177054 +638 2 6.67553 13.8767 6.05203 0.11849 -2.56514 -0.0944634 +639 2 6.15828 12.5051 6.51647 -3.32664 -1.56183 1.61673 +640 1 16.774 12.5213 9.71798 -12.6143 2.89661 19.2402 +641 2 17.0082 11.8947 9.03708 5.67192 -3.35034 -8.73073 +642 2 17.3962 13.2453 9.69208 4.02202 2.48097 -6.52464 +643 1 6.17384 2.92225 2.79448 3.9775 16.0199 -22.3947 +644 2 6.54801 3.78326 2.49667 -7.94175 -14.5768 11.9424 +645 2 5.69703 2.59738 2.01124 2.48224 -4.95439 10.1002 +646 1 10.7977 3.13994 3.23713 3.9771 -4.26255 2.57443 +647 2 10.0782 3.73781 3.45741 -0.0760182 2.97522 -1.01161 +648 2 10.5069 2.61778 2.47973 -3.48459 4.35709 1.40724 +ITEM: TIMESTEP +70 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.80152 6.81783 17.9876 -13.1435 8.65537 6.0931 +2 2 7.93927 7.0215 18.3978 9.39494 -6.73756 -6.11522 +3 2 8.64173 6.15327 17.319 -1.79792 -4.8767 -3.2487 +4 1 0.159104 8.33212 6.75565 -1.75886 1.86255 -0.283403 +5 2 0.400553 7.98898 5.87058 -1.56937 3.6046 13.6337 +6 2 0.532733 7.75931 7.44677 0.588181 -1.3305 -10.9259 +7 1 8.56014 0.2064 6.86713 15.1827 -2.1442 1.30375 +8 2 9.48839 0.201881 6.58247 -8.47619 -0.963055 4.35965 +9 2 8.1657 0.891093 6.32874 -5.18544 5.82437 -2.7504 +10 1 6.48158 1.74839 11.7303 -5.73112 -6.99234 -4.49671 +11 2 5.77966 2.25139 12.1582 1.03612 1.63173 -0.79005 +12 2 6.04661 0.9684 11.3341 5.10627 10.6526 7.94811 +13 1 6.96595 5.58057 2.38836 1.68885 13.6464 8.05547 +14 2 6.50498 5.94206 3.17078 2.94101 -7.34901 -12.8293 +15 2 6.93975 6.29059 1.72807 -1.07971 -9.74986 0.444847 +16 1 16.2371 10.2379 16.1019 -30.9876 -7.62323 7.88585 +17 2 17.0175 10.5802 15.7054 20.7335 11.057 -7.58035 +18 2 15.6477 10.9912 16.2983 15.508 -10.4523 -2.02188 +19 1 10.7008 14.9379 2.28795 4.31472 -8.51672 3.50984 +20 2 10.6635 14.2367 2.95607 -1.08681 7.31624 0.965 +21 2 11.2207 15.6296 2.69467 3.48557 9.19098 3.66151 +22 1 17.1795 8.23023 10.7992 8.53416 -1.59534 -8.67541 +23 2 16.5643 8.83199 11.2261 -1.39923 4.26423 7.56567 +24 2 17.9421 8.77596 10.5426 -4.34729 -3.75626 -0.741474 +25 1 14.6688 15.978 16.4285 2.33326 -11.9168 -2.20454 +26 2 13.7825 16.2968 16.2522 -6.84331 1.16869 1.85073 +27 2 14.5784 15.3806 17.1932 6.40998 12.5602 -6.81985 +28 1 12.1084 13.347 0.550082 18.7888 -12.4001 5.31554 +29 2 11.808 13.4241 18.2861 -6.00468 7.05887 -5.4437 +30 2 11.724 14.0175 1.12482 -9.88619 2.03399 -6.75529 +31 1 9.30709 5.48775 3.90966 3.41698 -5.29876 17.2174 +32 2 8.77877 5.25688 4.68667 5.61339 2.83044 3.00189 +33 2 8.64592 5.55872 3.2299 -8.10772 2.16644 -16.0449 +34 1 1.64595 4.02425 11.592 -10.9656 22.1289 -13.9701 +35 2 1.60629 4.97108 11.8395 -0.824037 -11.4025 -3.90562 +36 2 2.20491 3.59841 12.2231 10.5337 -11.1868 16.6964 +37 1 2.06621 6.87149 8.22737 1.24172 3.77126 1.52806 +38 2 2.50304 7.30143 8.97949 -2.75541 -3.2118 -2.64013 +39 2 1.97282 5.93715 8.45613 -0.171499 4.52155 4.26063 +40 1 5.3374 4.4954 7.902 -9.99384 -2.48662 -4.40208 +41 2 5.3873 3.53885 7.92862 5.32096 -10.0353 0.506932 +42 2 4.78906 4.68538 7.13029 -0.632429 8.18831 0.496784 +43 1 3.33945 2.92164 17.4119 -9.04777 -8.0172 12.2496 +44 2 4.01569 3.37904 16.9228 10.8208 5.2633 -7.4392 +45 2 2.90871 3.59334 17.9575 0.609467 0.189965 -2.29637 +46 1 7.45919 5.40741 6.16401 6.01334 0.147035 -1.33637 +47 2 7.84933 5.9815 6.83711 3.51741 -4.84398 -5.3698 +48 2 7.00259 4.70355 6.63733 -2.11297 5.93299 1.70682 +49 1 9.81228 7.01862 12.0561 -1.06857 0.870105 -3.24483 +50 2 10.2542 6.3375 11.5392 -2.78202 1.90065 -0.0845581 +51 2 9.1292 7.39963 11.4807 2.35361 -4.5728 1.86322 +52 1 13.9947 3.68643 8.08173 -5.65395 18.5094 -17.1015 +53 2 13.7843 4.54079 7.64233 1.50666 -18.9 8.64197 +54 2 14.1479 3.8993 9.00085 4.5059 2.7709 6.99075 +55 1 4.5073 17.1442 3.93435 4.48768 -12.0008 8.39889 +56 2 5.39081 17.5321 3.92633 -2.26089 2.72179 -5.35255 +57 2 4.01543 17.3459 3.13072 5.98217 13.0117 -0.399635 +58 1 16.4079 16.585 10.4121 -12.3499 -1.91652 -12.9082 +59 2 15.5551 16.5364 10.8674 2.44262 -0.34105 -1.56006 +60 2 16.2254 16.2298 9.51738 1.66683 0.349555 15.5208 +61 1 1.97926 4.78245 0.194184 -7.72676 6.8376 3.32149 +62 2 2.28164 5.2243 0.992573 8.53964 -6.59001 3.21257 +63 2 1.76914 5.52567 18.27 -2.63275 2.53007 -9.16672 +64 1 11.4134 13.2491 16.3873 0.68902 5.27402 2.7566 +65 2 10.9787 12.3908 16.4988 0.445492 6.36744 -3.52589 +66 2 11.9797 13.161 15.6117 0.593117 -3.37138 0.847423 +67 1 10.1151 10.9818 16.8138 12.4788 0.931853 3.10073 +68 2 10.558 10.1255 16.7937 -4.12284 -0.882862 -0.541555 +69 2 9.18349 10.8105 16.7424 -13.6774 -3.43657 -1.9902 +70 1 11.7994 17.4667 13.4795 12.7765 -4.5476 -2.07039 +71 2 12.3346 16.8373 12.9682 -4.67996 5.77396 2.18605 +72 2 12.2169 18.3179 13.2967 -7.11407 5.85224 3.16387 +73 1 6.41771 9.40938 12.2612 -1.11473 -8.0868 -15.4525 +74 2 7.03744 9.07449 11.5759 -13.2083 9.2101 17.4474 +75 2 6.9295 9.8935 12.9066 11.874 3.71682 2.38348 +76 1 16.2958 12.8923 2.71536 -7.68956 9.05075 5.11912 +77 2 17.1057 13.405 2.60095 0.726983 -7.0699 -1.53932 +78 2 15.5966 13.5689 2.77432 5.93986 -8.84533 -0.161974 +79 1 0.748159 12.7086 5.88144 -10.9756 -4.32923 1.80334 +80 2 1.126 12.5118 5.01571 -4.75041 4.90571 -2.30818 +81 2 18.4243 12.6438 5.75836 11.281 1.67442 1.09101 +82 1 5.27578 16.4085 18.412 4.21131 -11.5608 4.53747 +83 2 5.56823 15.5611 18.0525 -2.79743 5.31701 -3.02359 +84 2 5.61546 16.4141 0.666595 -0.372752 7.00853 0.303479 +85 1 0.645783 7.7249 4.17395 -22.5174 -18.1833 12.2453 +86 2 0.0406635 8.03244 3.50183 -6.8254 3.26088 -7.40309 +87 2 1.47404 8.07846 3.91568 30.354 9.58108 -9.75695 +88 1 3.15689 8.99663 6.46784 -29.6014 22.5811 -11.1032 +89 2 3.73467 8.6187 7.10087 15.4493 -13.4368 20.8179 +90 2 2.24881 8.95158 6.82736 13.2955 -4.68481 -5.71698 +91 1 7.31562 10.4015 16.2316 3.59442 1.76188 5.73087 +92 2 6.55849 10.6763 15.7162 -1.33577 1.2968 -0.922241 +93 2 7.0153 10.388 17.1537 0.717273 -3.98644 -9.35278 +94 1 11.0545 0.930228 4.99952 5.57476 -3.06583 5.10436 +95 2 11.2493 1.80197 4.63341 -8.70362 -0.159614 -5.22362 +96 2 10.8601 0.352804 4.24475 -0.891787 5.80331 3.4075 +97 1 4.31226 2.88036 13.174 -5.147 13.5187 -3.07305 +98 2 4.38813 3.36721 14.0053 4.89736 -4.04185 -0.502489 +99 2 4.16611 1.96327 13.4122 -1.31506 -9.67947 3.52696 +100 1 8.44169 10.2311 1.79631 7.56357 -11.9838 -1.9735 +101 2 8.31668 10.8926 2.47474 -4.45102 7.488 6.50539 +102 2 8.68604 9.43265 2.286 -2.4935 0.872154 -3.30188 +103 1 10.3613 1.71229 15.5051 2.98347 -4.15867 -5.41234 +104 2 11.2858 1.47948 15.6006 4.17674 0.252173 3.54686 +105 2 10.224 1.77346 14.5485 -4.83776 4.02156 4.39256 +106 1 2.62824 12.9587 7.89058 0.896502 -11.3927 -2.22701 +107 2 3.24219 13.4607 7.34422 -0.123332 4.88452 0.659902 +108 2 1.95928 12.6032 7.2874 1.64097 5.4786 -0.796639 +109 1 3.80872 11.636 4.95037 -11.7682 3.18495 22.2339 +110 2 3.64598 10.9456 5.61445 0.836076 6.10931 -6.44063 +111 2 2.95096 11.8687 4.56439 8.15456 -6.07271 -3.548 +112 1 6.68955 14.4669 16.969 -3.81156 3.78561 -6.36768 +113 2 7.31157 15.1356 17.2607 6.01474 -1.04117 -0.64393 +114 2 6.3928 14.7335 16.0851 0.840242 -1.58899 4.15547 +115 1 14.2051 14.5083 3.2908 -7.03725 6.3674 -0.58292 +116 2 13.7783 15.3639 3.15563 1.95336 -1.87129 -0.261548 +117 2 13.7683 14.1355 4.06228 2.52608 -4.66484 0.961916 +118 1 8.56009 18.0702 16.0712 3.20396 -8.67406 4.91505 +119 2 9.14753 17.3445 16.2475 -6.34669 -24.466 3.58587 +120 2 9.1857 0.126611 16.1642 1.87484 33.3672 -8.78222 +121 1 4.70115 1.72624 4.89274 27.4793 -6.96303 -5.48355 +122 2 3.95894 2.26041 5.13304 -17.2548 11.1403 -0.356707 +123 2 5.27782 2.26423 4.3214 -9.62564 -3.87491 4.20048 +124 1 15.0192 12.5587 16.5123 21.7041 14.8698 31.7439 +125 2 14.5985 12.983 17.2917 0.468388 -8.58398 -21.4185 +126 2 14.4797 12.5149 15.7347 -25.1252 4.80555 -9.98379 +127 1 15.7034 18.4851 16.8595 11.2428 14.4774 5.40242 +128 2 16.3726 18.3616 17.5507 -1.30019 6.81093 -3.04699 +129 2 15.2229 17.666 16.8625 -3.30988 -17.6635 -4.60623 +130 1 1.33118 1.27529 16.6047 -9.4861 0.393225 2.74141 +131 2 2.17004 1.71925 16.7831 -4.45817 3.09534 0.768406 +132 2 0.687638 1.66877 17.2201 8.28198 -2.79213 -3.95818 +133 1 18.1871 4.40384 15.9188 -4.2246 -5.6904 -13.4727 +134 2 18.0103 3.84369 15.1415 2.73285 7.2293 11.0268 +135 2 0.486098 4.58175 15.924 0.765927 0.250404 0.0527718 +136 1 12.1931 17.0307 16.1573 -7.03075 -8.39993 15.6705 +137 2 11.4402 16.4961 16.4862 10.3932 12.5123 -4.95214 +138 2 12.1197 17.0939 15.2076 -10.1529 0.179256 -12.7611 +139 1 16.106 2.59107 18.2096 -1.1157 3.6739 1.58184 +140 2 15.8464 3.51014 18.3379 -6.23469 -2.00336 3.76026 +141 2 15.8431 2.36085 17.3192 0.233798 0.882779 -7.24243 +142 1 6.71273 13.8002 10.1277 -4.97427 -8.24119 9.58999 +143 2 6.56779 13.4217 11.0085 1.93353 6.26249 -2.22943 +144 2 6.54815 13.0587 9.53715 2.49444 0.869035 -6.59786 +145 1 10.1873 18.4315 2.70955 18.3562 4.9239 2.5593 +146 2 10.5434 0.318979 1.97838 -6.6136 -2.73616 6.22508 +147 2 9.38189 18.0459 2.39836 -17.7025 -5.54205 -6.95436 +148 1 3.04496 17.7072 6.14474 -26.0897 -13.5421 -17.7616 +149 2 2.15406 17.5302 5.73662 26.1077 6.8467 16.2169 +150 2 3.64192 17.5514 5.40101 1.03601 7.77362 4.67988 +151 1 12.6273 16.8318 7.93854 -11.3452 0.662957 5.12661 +152 2 11.8845 16.2201 7.89678 1.40738 -6.80959 -10.3945 +153 2 12.3926 17.3902 8.68441 7.00662 7.84172 2.34647 +154 1 14.8855 15.2416 8.18261 -13.4645 13.8861 12.0711 +155 2 14.0556 15.7424 8.32689 13.5062 -6.9847 -4.51651 +156 2 15.2561 15.6092 7.37576 4.4997 -5.95581 -2.20609 +157 1 17.7963 18.2323 0.313468 22.8316 -1.73762 -16.8861 +158 2 18.5551 17.7341 -0.0636659 -20.2187 -0.580139 11.9305 +159 2 18.2144 0.43747 0.484185 -10.4644 5.54896 5.21224 +160 1 0.772309 10.5133 1.37975 -10.1333 -30.1062 6.79594 +161 2 0.0813059 9.81759 1.5081 15.2254 18.695 2.54909 +162 2 0.385285 11.1613 0.797203 -0.976125 9.32481 -5.57513 +163 1 1.78018 12.2676 3.33949 2.15539 9.4235 -7.57379 +164 2 1.54035 11.6193 2.6706 -4.1225 -6.27654 2.3776 +165 2 2.05243 13.0385 2.81809 -2.70385 -1.96831 6.56166 +166 1 0.659925 17.2426 4.96586 -18.1386 9.04401 18.0738 +167 2 0.178596 18.0473 5.21064 6.21229 2.02654 -16.1731 +168 2 0.324647 16.6226 5.62628 12.0605 -8.44774 -8.6881 +169 1 1.10032 0.835558 9.36207 -6.74911 6.08386 15.0138 +170 2 1.34007 0.666464 10.2949 -2.02307 -2.81345 -10.1719 +171 2 0.1714 0.592543 9.31025 -1.22709 -3.40717 -2.54195 +172 1 16.7505 2.35163 13.3289 8.60057 15.8485 -12.5846 +173 2 16.88 2.58008 12.3859 -1.48994 0.98841 16.7513 +174 2 16.5792 1.4154 13.3346 -5.94985 -15.1034 2.43107 +175 1 2.68711 15.9094 12.0537 -2.04437 -0.129745 31.1177 +176 2 3.02052 15.4906 12.8711 -6.40464 9.26827 -14.3072 +177 2 3.17282 15.5129 11.3342 0.535683 -2.02659 -8.3952 +178 1 16.4208 15.6182 6.1352 -21.1289 -3.6799 -9.5135 +179 2 17.2955 15.5836 6.51556 8.3115 3.57969 -3.1518 +180 2 16.3537 16.3493 5.49765 5.76519 -7.13598 7.22522 +181 1 5.79664 5.13529 11.8088 -4.38676 10.3557 2.90642 +182 2 5.60006 6.00552 12.2032 -0.739769 -8.67447 -3.0914 +183 2 5.02307 4.59055 11.9941 4.66701 -2.35447 -0.0408817 +184 1 15.1607 4.87263 0.806669 16.5091 -1.57376 7.82361 +185 2 14.8955 4.71033 1.72542 2.63671 -2.24198 -6.9535 +186 2 14.4069 5.23734 0.370441 -15.2288 7.71764 -6.62645 +187 1 16.3977 16.3968 1.96949 3.68196 12.8197 -24.7966 +188 2 15.8359 16.7471 2.65913 3.23547 3.93446 11.4731 +189 2 16.7724 17.1777 1.4991 -6.44753 -16.1278 10.1249 +190 1 0.213933 4.82135 3.88253 -26.808 7.93653 -12.3623 +191 2 0.234051 5.77519 3.99531 2.75938 5.29795 -1.25016 +192 2 0.961943 4.50047 4.34745 23.7428 -13.1307 13.4767 +193 1 2.96019 15.0595 15.1256 -5.74802 5.98414 7.79678 +194 2 2.74143 14.6748 15.982 5.94976 -7.2483 0.528018 +195 2 2.64636 15.9627 15.2549 -2.4967 2.40481 -11.2251 +196 1 1.11613 14.6445 9.47707 24.3082 -3.71628 -27.1602 +197 2 1.83443 14.0608 9.11052 -24.4018 17.7336 11.9542 +198 2 0.662892 14.1245 10.1216 -3.75634 -10.5151 15.6601 +199 1 13.5123 16.5361 11.5209 14.3415 8.92342 18.194 +200 2 13.0624 17.3115 11.1648 -0.833334 -0.722864 -7.66511 +201 2 12.9752 15.7809 11.2867 -3.03575 -6.70349 -11.2125 +202 1 4.68996 1.46706 0.718872 11.9134 2.33738 12.4928 +203 2 4.09477 2.04355 0.241198 -5.36661 3.4607 -5.79099 +204 2 4.1604 0.969338 1.36347 2.85434 0.638429 -14.0321 +205 1 1.49954 18.563 11.8891 -5.50653 18.8512 6.56283 +206 2 1.44134 0.571379 12.6129 -0.0136494 -9.64138 -5.67935 +207 2 2.21117 17.97 12.1221 3.30859 -8.66659 1.78907 +208 1 11.4402 10.1273 4.0296 -14.1313 -2.26429 -1.73879 +209 2 11.5467 10.5306 3.16018 -4.20959 -0.177974 3.37558 +210 2 12.3237 10.0244 4.36159 16.2917 -0.468181 5.60308 +211 1 8.19952 12.1987 3.67367 7.5254 -0.929385 2.30686 +212 2 9.06593 12.5735 3.89529 -5.56433 -0.233543 6.4332 +213 2 7.60827 12.3201 4.43288 5.90715 0.804339 0.890554 +214 1 14.5695 4.00736 3.30806 -0.853883 -3.91237 -3.28064 +215 2 15.2428 4.12216 3.97778 4.83301 -0.192226 6.11595 +216 2 13.7947 4.43075 3.66998 -10.7695 5.18811 0.448659 +217 1 5.68852 1.65707 7.54168 28.123 23.6896 24.0894 +218 2 4.98915 1.23464 8.0079 -23.0977 -17.1785 12.6492 +219 2 5.54722 1.47278 6.63267 -9.12733 -3.0122 -32.3212 +220 1 17.8871 1.01837 4.84182 2.82015 7.71075 0.411156 +221 2 18.4334 1.54735 4.24341 -1.55475 -9.21419 -1.50179 +222 2 17.685 1.60385 5.57556 -2.0638 -1.04483 2.6292 +223 1 6.8166 9.34907 4.51783 5.09473 -9.82493 1.7662 +224 2 6.68916 9.48214 5.46541 0.845655 -0.0829088 -1.52267 +225 2 7.72677 9.02302 4.42297 -5.47106 2.64724 -1.23342 +226 1 2.52902 14.8001 2.0243 -5.93162 -1.84873 -28.2955 +227 2 3.33024 14.7833 2.53171 11.9325 -2.28831 13.4023 +228 2 2.81062 14.7362 1.08886 -6.14041 -0.158095 16.8135 +229 1 17.2862 12.9192 13.1313 -13.4327 18.0081 -1.69868 +230 2 16.3974 13.2513 13.3936 19.5241 -4.39437 -6.93828 +231 2 17.8009 13.724 12.9107 -8.95295 -13.2998 3.51907 +232 1 14.8818 10.557 1.42323 -17.5015 7.25829 9.68839 +233 2 15.2835 11.3752 1.77244 -3.15433 -10.3089 -2.91904 +234 2 13.933 10.5609 1.67153 21.0133 3.93252 -5.34474 +235 1 5.70173 6.62264 4.58284 3.01718 2.50499 1.71703 +236 2 5.75902 7.56019 4.39794 2.55817 9.91828 -0.0203224 +237 2 6.42399 6.43452 5.20085 -6.85011 -4.70646 -2.52597 +238 1 8.0341 8.36204 10.3892 10.4405 -6.77488 -14.8808 +239 2 8.6296 8.90948 9.85447 -2.74542 2.30932 7.48232 +240 2 7.64772 7.74454 9.75603 -3.95063 2.60786 3.00172 +241 1 13.4272 18.4528 5.67238 9.25795 -5.11499 9.49722 +242 2 12.7163 0.440246 5.56173 -10.019 1.98309 -6.96611 +243 2 13.1619 17.9514 6.45613 2.7128 -4.57063 -2.8 +244 1 -0.0270522 2.62208 0.316378 14.2494 -14.2567 4.73545 +245 2 17.7181 2.78355 18.7164 -19.3625 -8.86024 -5.69671 +246 2 0.361548 3.46719 0.160861 21.2807 17.6319 0.792983 +247 1 12.9304 10.9756 9.73287 -28.9199 -18.5822 3.85047 +248 2 11.9453 10.9259 9.78333 22.7984 8.3459 -7.73181 +249 2 13.1639 10.0723 9.99967 2.00349 4.19966 -2.07729 +250 1 0.632704 12.1509 11.1096 7.92792 10.2243 1.08862 +251 2 18.3238 12.1837 11.2671 1.30826 1.36738 8.17016 +252 2 1.12128 12.4175 11.9061 -11.5401 0.628467 -1.63311 +253 1 5.16172 7.34292 13.3779 5.89076 -0.786387 1.26512 +254 2 5.63913 8.13751 13.0818 -0.253704 -8.62988 -1.18816 +255 2 5.64992 7.00871 14.1461 -2.49218 7.71701 -3.25354 +256 1 1.18315 6.80996 11.9457 -21.1971 9.90527 -11.1777 +257 2 0.396163 7.2181 11.5121 19.4256 -12.5543 10.5539 +258 2 1.74685 7.55572 12.1675 3.51989 2.12142 1.71712 +259 1 15.5171 9.71047 12.3281 2.29457 -6.5479 -4.23973 +260 2 15.3017 10.6102 12.0519 -2.15799 -4.39765 10.01 +261 2 15.6816 9.70968 13.2745 -0.591496 3.33032 -0.321137 +262 1 16.5873 12.6729 5.56721 2.76163 -0.166181 -5.31991 +263 2 16.3773 13.5773 5.84608 0.225425 -0.965456 -7.72797 +264 2 16.4542 12.6253 4.60029 -0.729256 4.09093 10.083 +265 1 6.36605 9.79142 0.024922 -16.0501 18.8211 -0.426432 +266 2 5.53971 10.2677 0.213525 8.17613 -4.10964 1.60097 +267 2 6.98218 10.0336 0.714657 7.30358 2.91784 7.9977 +268 1 12.2857 6.09281 4.02237 -18.7873 -18.2554 10.8389 +269 2 12.2499 6.90248 3.51498 -0.180994 1.77121 -11.4426 +270 2 11.3769 5.71462 3.99073 18.6718 6.8659 -0.0124277 +271 1 0.371339 12.8581 0.116813 -11.2914 -0.881026 -5.3546 +272 2 18.6979 13.4634 0.798717 1.88955 0.580482 0.906428 +273 2 18.4407 13.0157 17.9982 0.051521 1.66817 1.81741 +274 1 3.57562 18.6672 8.63597 16.8652 -4.29809 -8.00937 +275 2 3.39672 18.3023 7.75382 0.438355 1.17547 6.33464 +276 2 2.72388 0.290377 8.97499 -6.05452 1.31479 -1.62581 +277 1 7.38199 17.3678 4.46374 -1.38292 15.3105 6.33947 +278 2 7.69148 18.255 4.75287 -6.89683 -17.7129 -9.79531 +279 2 7.51455 17.3077 3.50947 0.595015 4.11355 1.7546 +280 1 9.26329 17.1448 12.185 -8.64248 6.96454 5.63337 +281 2 9.31183 16.2501 11.845 1.80177 -5.78684 -3.53436 +282 2 9.93599 17.2354 12.8685 5.43729 -1.39148 -3.55242 +283 1 13.2821 13.1028 8.02698 11.8692 -15.3168 6.16039 +284 2 13.4688 12.3189 8.5813 -8.97739 12.1367 -7.14337 +285 2 14.105 13.618 8.04076 -8.38267 2.98351 0.0644509 +286 1 14.8025 2.98142 15.4294 17.4288 1.80056 -2.61073 +287 2 14.201 2.26032 15.2834 -13.2348 -7.60023 -2.35086 +288 2 15.3302 3.01554 14.6169 0.118996 0.402428 5.45631 +289 1 9.92493 15.6251 16.9821 6.00495 -5.53666 -0.13681 +290 2 10.4191 14.8506 16.6821 -3.27256 -3.64184 -5.012 +291 2 9.59076 15.3546 17.8439 -3.58917 5.2502 2.724 +292 1 11.2797 8.49868 16.6198 -1.73472 -6.52809 -3.79184 +293 2 10.75 7.88393 16.0952 -2.42874 5.03231 0.808132 +294 2 11.4092 8.05007 17.4587 2.82097 -1.86681 0.519814 +295 1 4.04678 18.2455 16.7988 -8.77416 25.1666 -6.65304 +296 2 4.65779 17.694 17.284 2.06605 -2.99109 10.2548 +297 2 3.96053 0.454509 17.276 5.60906 -19.8799 -5.16878 +298 1 2.27095 4.25175 8.91936 5.9784 -6.58712 9.82608 +299 2 3.2186 4.2524 8.72216 -4.79336 -1.38402 1.94738 +300 2 2.18112 3.96584 9.85003 1.09756 8.39619 -11.3917 +301 1 9.88624 10.3936 9.78011 6.22166 -2.86793 -13.7384 +302 2 9.62293 11.2772 9.51568 -5.75811 3.67729 -6.27375 +303 2 10.0642 10.4241 10.7104 0.548842 -0.969577 22.0405 +304 1 9.71663 0.937962 10.8586 -0.709221 -7.70358 -11.4846 +305 2 9.30987 0.134657 11.1937 5.18354 -4.14977 6.17978 +306 2 9.11908 1.1943 10.1452 4.37988 8.3302 1.85952 +307 1 9.18198 15.0956 10.1953 -4.26962 6.22766 7.58802 +308 2 8.89777 15.9846 9.95951 0.743088 2.4445 -7.53567 +309 2 8.34997 14.6032 10.2066 5.52748 -3.88041 -1.79992 +310 1 0.872205 9.70338 10.2435 26.5305 -15.7209 -40.6294 +311 2 0.885793 10.5746 10.6186 -2.04601 10.7115 5.01116 +312 2 1.5471 9.74995 9.50099 -28.1395 -6.59839 33.8889 +313 1 17.1072 4.85649 8.10795 10.9462 -15.5033 5.93553 +314 2 16.3968 5.45295 8.31142 -11.4282 10.1371 2.96807 +315 2 17.1775 4.27052 8.87929 1.82351 6.10377 -11.9311 +316 1 14.794 14.6968 0.0807509 -15.0506 -16.2211 -7.1198 +317 2 15.1293 15.3316 0.707575 7.57499 5.98458 11.2724 +318 2 13.942 14.3729 0.412504 5.92115 1.12787 4.02247 +319 1 3.8058 11.0463 9.54758 -4.72716 5.89465 -11.0149 +320 2 3.75265 11.4758 10.4012 1.08641 -1.46789 11.7249 +321 2 3.34125 11.6425 8.94232 1.4747 0.62014 0.836248 +322 1 11.3036 10.7395 1.51518 17.421 7.70001 -9.9965 +323 2 11.5572 11.5513 1.04939 0.916953 -2.49636 4.28379 +324 2 10.3663 10.6689 1.38091 -17.6315 -2.91035 -1.9437 +325 1 13.1498 7.19173 12.6392 -12.6781 -12.1868 5.62798 +326 2 14.0645 6.9093 12.7169 6.63809 2.55694 -2.55252 +327 2 12.6264 6.38473 12.8035 6.43409 8.48166 -2.8301 +328 1 9.6244 1.91603 0.948782 1.73007 4.87205 -17.2591 +329 2 8.78103 1.84907 0.47922 2.387 -4.26061 4.8929 +330 2 10.2561 2.20979 0.275304 -2.56753 1.91417 5.98087 +331 1 10.6541 13.4625 4.53479 -4.64228 5.78216 2.02785 +332 2 11.5543 13.1406 4.67483 -3.60366 -2.8444 3.58336 +333 2 10.4931 14.1115 5.23949 3.28752 -7.90473 -1.94244 +334 1 14.4847 1.66582 10.9548 -5.6847 9.24739 -2.41061 +335 2 15.2495 1.25185 10.5509 3.51804 0.734089 -1.48015 +336 2 14.6665 2.62215 10.9157 -2.44239 -9.64589 2.94827 +337 1 14.5153 12.0551 11.6598 -8.57838 4.331 1.02894 +338 2 15.2406 12.4341 11.1775 15.6624 8.75252 -5.54666 +339 2 13.8905 11.8145 10.9694 -5.00706 -1.53612 2.9308 +340 1 8.18805 5.09916 9.82303 -13.8101 6.02591 4.86356 +341 2 7.31243 5.14562 10.2589 14.5937 -0.354252 -5.27398 +342 2 8.2462 4.20505 9.47267 -0.0530366 -3.80538 1.315 +343 1 1.47125 16.9173 18.4665 17.3664 16.657 -21.1079 +344 2 1.9236 17.2269 17.6455 -9.65792 -6.20403 18.6505 +345 2 1.59593 15.9726 18.4726 0.464255 -9.97504 -1.82966 +346 1 1.48039 17.3287 15.3228 1.51401 14.0556 6.72393 +347 2 1.34693 18.2292 15.6575 8.56134 -5.76509 -0.66881 +348 2 0.596093 16.984 15.2507 -11.2139 -7.77617 -1.25224 +349 1 3.58273 5.77174 6.05172 -7.98503 -18.1926 7.56457 +350 2 3.04578 6.35459 6.60151 3.24577 3.33226 -0.333817 +351 2 4.18271 6.30655 5.53303 2.15541 4.89174 -3.71227 +352 1 12.4965 9.48476 14.2165 -0.670713 16.0192 -6.73881 +353 2 12.9556 8.76438 13.7775 2.07937 -6.9932 3.10842 +354 2 12.3436 9.22115 15.1264 1.05397 -7.72063 3.19376 +355 1 4.0654 15.2599 7.01126 14.536 -9.99762 3.77636 +356 2 3.57418 16.0458 6.77165 -4.77502 7.81332 -2.1228 +357 2 5.00035 15.4681 6.83264 -6.89866 -1.23873 3.67355 +358 1 0.723833 8.69198 15.0851 1.39297 0.947643 -5.33928 +359 2 0.438801 9.60781 15.1421 -2.06214 4.43911 1.45744 +360 2 1.38458 8.70272 14.3802 0.858615 -3.42768 2.38717 +361 1 12.8756 8.29184 10.1606 18.5084 -5.85873 3.08502 +362 2 13.7209 7.89345 9.85142 -16.8549 4.13316 8.30657 +363 2 12.7515 7.97965 11.0724 6.23426 1.04322 -7.42686 +364 1 15.3229 7.8277 3.50947 17.5558 22.7432 -34.5468 +365 2 14.4697 7.71438 3.07339 -7.31906 -8.87793 15.8657 +366 2 15.4806 7.65388 4.43399 -18.8005 -15.0751 11.2523 +367 1 17.2596 6.73529 0.0260639 -2.34928 8.60384 0.474092 +368 2 16.7705 6.01921 0.434638 -6.55856 -4.92879 -0.567585 +369 2 16.5991 7.41683 18.4475 3.41319 -8.53114 -0.808778 +370 1 8.95463 6.95692 7.78734 -12.7059 -4.64784 9.91199 +371 2 9.87027 7.23168 7.81087 8.51327 4.71948 -0.0600656 +372 2 8.83651 6.35153 8.53608 0.68522 0.961995 -1.89804 +373 1 12.4059 0.607414 1.26231 3.62116 2.02707 -9.0712 +374 2 13.2571 1.01103 1.48145 3.02509 -6.80244 -1.55076 +375 2 12.4394 0.42011 0.312768 1.30302 -0.072107 7.45087 +376 1 5.61221 15.1181 14.5069 21.81 1.56396 -5.03583 +377 2 4.69671 15.2613 14.7447 -7.9418 2.21424 1.99916 +378 2 6.02853 15.9808 14.3125 -8.14435 -8.16553 0.0834836 +379 1 3.81616 6.42663 1.71897 -4.74342 3.6354 -4.79161 +380 2 3.34042 7.16969 1.31421 3.65203 2.80462 3.7212 +381 2 3.89499 6.64183 2.65143 -2.11765 2.44111 2.19083 +382 1 3.90516 11.4598 12.3793 9.45586 -8.94044 -12.3546 +383 2 4.79548 11.8227 12.4942 -7.15738 -0.735807 -0.876075 +384 2 3.31554 12.0782 12.7961 -9.4854 7.67777 7.65311 +385 1 5.30665 3.87758 15.8091 -6.5654 14.2288 -0.0449474 +386 2 5.99806 3.22942 15.6938 11.0923 -7.17561 -6.6845 +387 2 5.74209 4.7421 15.8325 -0.91092 -4.98763 -0.535492 +388 1 14.1952 10.2038 4.61463 -6.5923 1.74463 -22.8561 +389 2 14.2343 9.86507 5.49824 4.23866 -7.49318 19.2708 +390 2 14.5963 9.53108 4.04607 2.17028 4.66107 2.75401 +391 1 7.63145 17.3499 9.0679 -5.43123 5.71002 -0.0698024 +392 2 6.89643 17.6949 9.58041 -2.21022 -5.88459 7.45639 +393 2 7.83827 18.0718 8.46746 8.40651 -1.69566 -7.5742 +394 1 4.52514 14.4769 3.85867 5.05038 7.53463 5.39007 +395 2 4.64261 15.388 4.18066 -3.91408 -9.29834 -6.31781 +396 2 4.46355 13.9264 4.6465 1.7827 -2.93555 -2.6265 +397 1 14.2493 7.38723 15.8586 4.87219 -5.15553 -0.709446 +398 2 15.1473 7.29965 15.5014 -5.21416 1.68161 3.76194 +399 2 14.3665 7.7773 16.7353 0.544226 -0.39761 -4.2243 +400 1 3.0581 18.4144 1.95119 -22.1859 -8.41359 7.65322 +401 2 2.57832 17.7386 1.43356 3.30075 12.2585 2.4632 +402 2 2.38613 0.281938 2.45339 8.18993 -10.3808 -10.0068 +403 1 7.97435 1.63455 4.58282 23.9975 -9.20271 -17.826 +404 2 7.40194 1.94347 3.87976 -9.32013 4.13397 -1.27928 +405 2 8.80392 1.4125 4.10448 -12.4762 5.5818 15.8983 +406 1 2.4378 14.1623 17.6894 -3.94912 5.20331 -2.53114 +407 2 1.6661 13.615 17.8755 3.58117 1.8004 4.78536 +408 2 3.18519 13.6404 17.9779 13.28 -5.73443 1.82606 +409 1 0.901685 1.86492 13.8925 12.6905 0.691236 2.76957 +410 2 0.97461 1.67681 14.8348 2.02403 -0.73996 0.457614 +411 2 -0.0244921 1.99897 13.7259 -14.1961 2.08272 -4.4518 +412 1 4.37872 0.0904002 13.8777 13.1739 1.11326 -7.50903 +413 2 5.30332 18.4699 13.7308 -6.52685 1.52196 1.48666 +414 2 4.22979 18.5754 14.8098 -5.10379 -2.3914 9.04502 +415 1 7.27651 0.845893 18.3957 -16.6762 17.2151 26.568 +416 2 7.1678 0.492927 17.521 -0.448362 -6.22938 -12.6047 +417 2 6.39207 1.1517 18.718 17.8505 -10.612 -11.3067 +418 1 15.9607 18.375 13.9642 -35.6371 5.35013 -16.5011 +419 2 15.0008 18.4642 13.7578 26.2499 -2.51915 -0.30366 +420 2 16.0214 0.00880953 14.871 6.50934 -2.46523 19.0717 +421 1 10.2176 4.60873 16.2514 5.45645 -16.296 -9.2455 +422 2 11.1834 4.4434 16.3559 -20.4013 6.80033 -5.0518 +423 2 9.84346 3.80184 15.8357 11.7075 10.859 12.3241 +424 1 15.9288 17.6854 4.49702 -25.8895 1.84686 -2.2825 +425 2 16.5611 18.3979 4.49336 8.57016 10.0602 -1.14853 +426 2 15.0697 18.092 4.72548 12.7214 -6.58434 0.45321 +427 1 6.97646 17.4765 13.8835 1.51347 6.32825 6.74987 +428 2 7.46829 17.7625 14.676 -2.92413 -3.08896 -9.25103 +429 2 7.63479 17.4162 13.1781 -0.793447 -1.23312 2.0982 +430 1 13.2369 6.46193 6.55272 7.97686 -7.07829 -14.9633 +431 2 14.2045 6.47863 6.50403 -7.11621 7.88379 2.07663 +432 2 12.9571 6.40302 5.61769 -2.27464 -2.27743 14.9713 +433 1 7.84752 2.28013 9.41028 -8.73892 -0.731414 -17.5278 +434 2 7.29261 2.26329 10.1936 -2.39479 -1.12016 7.77392 +435 2 7.27021 1.99883 8.67538 7.42107 2.89864 6.55304 +436 1 15.163 14.8378 13.7075 -5.08255 6.9114 -1.94911 +437 2 14.828 14.9803 14.5966 0.517852 0.790599 5.03408 +438 2 14.8205 15.5736 13.1818 1.46712 -6.90646 -0.613497 +439 1 9.40195 8.33905 3.81803 -16.6236 -1.1153 -3.723 +440 2 10.1861 8.88666 3.81624 11.7714 1.21262 5.85608 +441 2 9.65895 7.42947 4.01423 -0.646232 2.08147 -2.76231 +442 1 17.7496 13.6056 16.4496 1.61536 7.2683 -6.30775 +443 2 16.7925 13.5164 16.4445 -3.33508 -5.74033 1.31806 +444 2 17.9176 14.3949 15.9026 -1.24178 -7.25826 8.29135 +445 1 4.89231 10.51 2.8606 23.2586 -26.6571 -20.5821 +446 2 5.63741 10.0083 3.24852 -7.78968 12.4235 -4.83768 +447 2 4.54582 11.03 3.56787 -4.03679 11.8248 12.8852 +448 1 3.69823 8.4002 10.0127 -3.60192 -11.2793 13.5005 +449 2 3.83759 9.3113 9.76164 0.279778 8.83932 -1.11316 +450 2 3.64192 8.42085 10.9836 -1.53751 -1.28356 -9.75822 +451 1 15.9467 6.92332 5.94112 11.8737 -8.24502 3.37919 +452 2 16.7476 7.39494 6.19571 -0.497479 1.69122 3.51528 +453 2 16.2467 6.02535 5.70675 -5.68891 13.7396 -0.851978 +454 1 15.1658 7.18492 9.0507 -10.4703 -15.8706 0.47552 +455 2 15.9236 7.59272 9.46168 11.862 8.93317 3.67812 +456 2 14.9906 7.60382 8.20629 4.02444 8.70872 -4.23998 +457 1 6.21618 12.8841 12.7284 -3.21766 12.2709 11.5322 +458 2 6.77909 12.207 13.0973 14.7659 -5.65099 1.01901 +459 2 6.15827 13.5741 13.4151 -3.2657 -3.93324 -9.28774 +460 1 12.1165 4.51288 13.1048 -1.62418 -0.0716723 20.7898 +461 2 12.3817 4.58382 14.0419 2.18295 3.85449 -11.1604 +462 2 11.2475 4.10019 13.1569 -0.321339 -3.45694 -9.73345 +463 1 11.4166 8.11249 7.92599 8.37678 -3.86112 -10.8327 +464 2 12.0468 7.60844 7.37796 -5.38848 4.21425 7.2331 +465 2 11.8428 8.18692 8.79136 -5.59584 -0.0130509 -4.24997 +466 1 17.091 10.8655 7.57222 -5.5019 -10.6926 10.9756 +467 2 17.8562 10.3128 7.37833 -2.02493 -0.998523 -7.2616 +468 2 16.8515 11.3839 6.80089 6.08197 4.8342 -8.48749 +469 1 5.2937 18.1227 10.8823 3.58086 -4.72457 -4.80722 +470 2 4.89277 17.7527 11.67 -2.28546 -3.10604 1.32943 +471 2 4.67512 17.9479 10.167 -5.31481 4.288 -3.34371 +472 1 7.59808 17.4966 1.71058 0.398559 1.64094 13.9409 +473 2 7.8828 16.705 1.25288 5.11743 -4.18927 -7.63945 +474 2 7.62118 18.2252 1.08608 -3.03358 1.0728 -8.8916 +475 1 1.91712 12.8862 13.5909 8.98798 9.32187 -3.03347 +476 2 1.48166 12.3531 14.2581 -2.09819 -2.06604 3.51643 +477 2 2.30811 13.6552 14.041 -7.16378 -5.11315 -1.13098 +478 1 9.42828 6.75322 14.7826 20.1915 -11.5504 -11.1057 +479 2 9.8277 5.94835 15.1588 -6.88663 6.02054 3.69259 +480 2 9.80073 6.79406 13.8821 -8.1098 8.28496 9.35183 +481 1 15.2968 4.25709 10.7854 2.83104 8.23395 -4.89519 +482 2 16.2313 4.08269 10.6128 -5.94582 -2.20316 7.08238 +483 2 15.3124 5.02999 11.3646 -3.5924 -3.42311 1.83328 +484 1 11.2927 6.22318 0.123361 12.5475 12.622 0.859144 +485 2 11.5233 5.29113 18.7512 -7.74436 -5.44097 -5.24926 +486 2 10.3808 6.34995 18.4806 -0.327163 -9.85792 5.03233 +487 1 18.5472 11.423 14.9732 18.3726 -20.3084 16.0571 +488 2 18.105 11.7915 14.2257 -13.2839 12.4126 -20.1368 +489 2 18.4564 12.0929 15.6514 -4.79118 8.10765 5.85542 +490 1 7.00881 9.27577 7.32015 -11.3868 -9.38104 -0.512081 +491 2 6.68278 8.41602 7.64312 1.53223 10.0212 -0.264373 +492 2 7.94615 9.16913 7.19167 13.4366 -2.83724 0.374421 +493 1 18.3388 15.3149 12.278 7.79295 4.11927 0.907342 +494 2 0.562248 15.7272 12.1255 -3.32497 -4.13752 -3.12696 +495 2 17.7171 15.7348 11.6722 2.18188 4.14775 -1.5511 +496 1 16.4968 4.40066 5.28798 -9.94208 -5.06851 -0.773295 +497 2 16.7853 4.2225 6.18546 2.9967 -3.39819 7.99443 +498 2 17.2662 4.33461 4.72457 15.1936 4.75592 -3.34352 +499 1 17.7173 3.18772 10.7866 10.4448 7.42964 -1.18609 +500 2 18.6422 3.37989 10.9855 -1.52891 3.674 4.44234 +501 2 17.7488 2.39891 10.2588 -4.04978 -15.6839 -7.32077 +502 1 12.3149 18.6145 10.0881 -2.22129 4.11252 3.54852 +503 2 11.4444 0.333084 10.2939 -3.02626 -1.86973 1.00626 +504 2 12.9201 0.705852 10.2372 4.71846 0.03299 -1.96706 +505 1 10.3684 9.76179 12.4758 17.9734 4.74974 2.50525 +506 2 11.1916 9.84607 12.9926 -11.8304 0.187235 -1.96375 +507 2 10.3012 8.81681 12.3218 -3.77483 -3.01576 0.0814472 +508 1 0.689392 2.74058 7.08104 -5.98449 10.1616 9.8561 +509 2 0.88859 3.44563 7.72485 0.581102 -9.26818 -8.93017 +510 2 0.974446 1.93578 7.5088 2.3916 -6.77547 7.05728 +511 1 0.277472 15.3259 6.84135 0.228059 -1.31559 -11.5462 +512 2 0.516029 15.5821 7.71821 6.50181 -1.47438 23.8891 +513 2 0.58839 14.4222 6.74639 0.679055 -1.95969 -5.2972 +514 1 17.0529 6.97528 15.0633 10.9144 -7.53558 1.72506 +515 2 17.8201 7.55974 14.9678 -6.11827 1.26888 -1.51964 +516 2 17.4266 6.16431 15.4413 -5.39729 2.11926 -0.659196 +517 1 9.11957 12.4732 8.03484 -32.1356 7.88594 4.6652 +518 2 9.41535 11.8783 7.35952 15.5672 -13.5118 -9.19924 +519 2 8.15954 12.512 7.86156 14.5216 4.72308 9.92056 +520 1 1.18275 1.7303 2.88012 3.13258 6.74516 -6.07855 +521 2 0.990874 2.23802 2.08159 -8.2151 -5.8717 0.0306137 +522 2 1.74436 2.31191 3.39299 4.34337 2.29394 9.11202 +523 1 4.11863 15.0886 9.98721 11.0177 -1.77256 -13.134 +524 2 4.02022 15.2012 9.03136 -3.58336 0.815549 3.23991 +525 2 5.04995 14.8741 10.1041 0.462863 -2.8957 0.615957 +526 1 7.38268 2.21023 14.7219 2.37064 11.9314 4.06902 +527 2 7.04717 1.62795 14.04 0.302375 -0.796384 -5.36483 +528 2 7.78873 2.97247 14.2654 -8.69617 -12.215 6.09363 +529 1 18.4343 14.5687 2.16054 8.35658 -0.618946 0.782777 +530 2 0.682906 14.919 2.34098 -12.2336 -1.59186 -0.620803 +531 2 17.7977 15.2902 2.22089 3.32879 4.73949 -0.959115 +532 1 10.0087 2.72001 12.9057 2.08485 -1.52945 -12.9938 +533 2 10.0412 2.17732 12.096 -1.38389 3.39971 12.264 +534 2 9.25575 3.30628 12.7713 -2.15732 -0.406341 3.704 +535 1 2.9831 8.88024 13.0189 0.952466 11.8173 -3.08609 +536 2 3.31938 9.77893 12.8076 -5.04245 -14.2298 4.61688 +537 2 3.71596 8.41411 13.4449 -4.1112 -0.429279 -5.2011 +538 1 3.20203 8.5912 3.76846 -11.4045 -12.6583 26.9753 +539 2 3.76961 9.22975 3.3591 6.50161 14.1888 -13.0281 +540 2 3.15464 8.85629 4.71231 4.40411 -9.17072 -19.7321 +541 1 5.64764 7.22249 8.60582 -2.45044 -0.628932 2.27153 +542 2 5.55364 6.27099 8.49955 3.15339 -1.29251 -2.67256 +543 2 4.90409 7.47651 9.17344 9.24373 2.45699 -1.73114 +544 1 14.907 1.53023 1.85078 -7.37767 -15.1485 8.29721 +545 2 14.668 2.24872 2.45072 11.5035 7.56218 -5.89301 +546 2 15.6059 1.77377 1.2289 -9.91057 9.46649 1.95684 +547 1 8.55561 15.0845 0.759561 -2.78586 4.97755 1.3099 +548 2 9.2232 15.1059 1.46635 -5.75771 -3.12613 -8.68727 +549 2 7.79979 14.5909 1.11068 3.03755 -1.08449 1.22088 +550 1 15.5064 1.39564 7.20176 -2.04619 -6.07348 -4.735 +551 2 14.846 0.870461 6.73047 4.3658 -0.949999 1.00211 +552 2 15.0733 2.23713 7.35024 -3.19526 7.79987 5.63196 +553 1 4.99693 12.9582 18.4618 -8.43591 -3.95032 12.7964 +554 2 5.427 12.9558 0.691187 -3.21166 1.68806 -6.66553 +555 2 5.5701 13.4759 17.8974 6.4766 -1.03013 -3.5001 +556 1 15.3823 8.61159 18.0651 4.42877 2.22092 -6.07372 +557 2 15.8154 9.23321 17.4587 -2.51695 -7.00562 1.90652 +558 2 15.1591 9.14089 0.186524 -1.03798 5.78876 7.10622 +559 1 12.0334 3.10844 18.3299 11.3082 -20.8993 7.10454 +560 2 12.3341 2.61645 0.471712 -7.66483 12.171 -5.21514 +561 2 12.3614 2.54753 17.6085 -4.58122 9.25845 0.807451 +562 1 13.192 12.7001 5.16537 5.21593 -6.7049 -2.26257 +563 2 13.6127 11.9331 4.74049 -3.39065 6.67562 5.25333 +564 2 13.2679 12.5364 6.11315 0.126366 6.17512 0.133491 +565 1 6.11282 7.21918 0.158665 1.88014 -14.5403 11.0752 +566 2 6.12514 8.17662 18.815 -2.86446 -0.617519 -0.818148 +567 2 5.41227 6.95692 0.781338 0.907384 -1.18964 -10.3034 +568 1 17.7111 15.8907 14.9544 -3.82577 1.28333 3.96962 +569 2 16.7386 15.9987 14.9233 18.3395 -0.0507343 -6.61585 +570 2 18.0408 15.7242 14.0577 -12.1828 1.42979 -0.226855 +571 1 13.1366 0.926204 16.6604 -4.9212 9.87611 -1.92759 +572 2 14.096 0.89187 16.7156 4.29984 -5.34206 5.94224 +573 2 12.8563 0.0335376 16.4436 -2.56348 -3.63873 3.02874 +574 1 10.9184 14.5253 7.38829 1.38398 -2.03118 7.00079 +575 2 10.1136 14.2278 7.85844 13.304 -1.52714 -8.95405 +576 2 11.6006 13.8396 7.51991 -9.17062 7.88742 -1.04716 +577 1 17.6363 8.46247 2.12178 -2.04395 4.31685 9.18728 +578 2 16.787 8.41765 2.58806 4.70486 1.56362 -5.63911 +579 2 17.6123 7.75928 1.47082 0.631216 -3.65047 -4.17578 +580 1 12.4375 7.79355 2.00637 -2.34281 23.5579 2.73553 +581 2 11.9501 8.63365 1.95534 8.51098 -6.49732 1.55884 +582 2 12.0343 7.24559 1.33225 -2.11395 -7.52965 -2.88654 +583 1 12.0451 14.5968 10.4885 2.58602 -10.5702 -25.2135 +584 2 12.3016 14.3716 9.56719 -0.183055 2.34539 21.1217 +585 2 11.1058 14.7694 10.4266 -10.5567 0.791778 1.58055 +586 1 6.78603 6.87835 15.4866 -3.36028 4.68136 22.1121 +587 2 7.71026 7.02894 15.2668 2.14313 -2.1467 -3.22881 +588 2 6.63472 7.41247 16.2893 -0.664868 -8.24615 -12.946 +589 1 7.99755 4.5041 13.3499 24.8278 34.1767 5.68201 +590 2 7.17338 4.66838 12.8997 -9.34484 -1.26894 -9.57598 +591 2 8.42297 5.40326 13.4231 -14.2483 -32.2403 1.51042 +592 1 13.3614 12.2059 14.3726 -2.68828 -3.01756 -2.25781 +593 2 13.124 11.2722 14.2967 -0.0467593 -0.437755 2.8377 +594 2 13.7081 12.4264 13.5024 2.10157 3.54991 -1.69903 +595 1 14.5654 9.5448 7.2719 7.4337 1.87458 1.84958 +596 2 15.4192 9.97446 7.42049 -0.421966 -1.69006 0.109976 +597 2 13.9603 9.96019 7.88547 -6.00597 1.06642 2.40823 +598 1 12.7021 16.8399 3.28406 2.1329 2.22559 -4.89416 +599 2 12.9627 17.2776 4.09814 -1.16793 0.633127 5.57798 +600 2 12.5029 17.5595 2.67417 -2.21511 -1.15635 -1.62469 +601 1 1.01088 7.06774 17.3689 20.0897 -7.47151 2.1243 +602 2 0.171968 6.83932 17.7636 -13.4375 4.7826 3.09836 +603 2 0.861358 7.69882 16.662 -3.49993 1.38105 -6.69635 +604 1 12.9265 4.90969 15.692 -1.72339 7.7777 5.20839 +605 2 13.7461 4.44088 15.8455 2.50132 -9.36464 -4.69309 +606 2 13.1831 5.83499 15.7716 0.254864 4.72294 -0.0726576 +607 1 2.3277 3.38915 5.11911 5.08689 -5.27649 -8.37414 +608 2 1.81648 3.03652 5.84872 -5.99705 -1.71944 1.12123 +609 2 2.79757 4.13118 5.49603 6.03185 12.6803 -1.33855 +610 1 8.22299 10.983 13.6596 -2.68868 6.78672 22.55 +611 2 8.37046 10.9349 14.6227 -7.71168 -0.54916 -12.6902 +612 2 9.06889 10.7219 13.2955 2.07822 -5.6604 -8.58071 +613 1 12.9566 1.54883 13.2404 -6.45532 19.0424 -4.61407 +614 2 13.4436 1.59622 12.409 4.66376 -6.5769 4.30334 +615 2 12.5511 2.44176 13.2892 3.97521 -19.3883 2.5587 +616 1 6.59697 13.6382 2.12308 -19.53 14.6785 -2.92569 +617 2 5.9569 13.9305 2.80289 7.92829 -3.31956 -9.9577 +618 2 7.23585 13.1086 2.59101 5.128 -6.56439 5.02766 +619 1 15.8657 6.47234 12.6041 4.99369 -6.06314 4.28807 +620 2 16.4551 6.98041 12.0348 -2.62867 1.80518 0.0955392 +621 2 16.3109 6.45259 13.4696 -4.62358 3.40022 -7.66147 +622 1 16.7868 0.706192 9.5524 8.10763 10.4692 12.0206 +623 2 16.4993 18.5236 9.95191 3.55616 -11.3811 -4.24312 +624 2 16.3059 0.843102 8.73445 -6.13335 -2.9453 -10.1224 +625 1 6.15553 11.6636 8.28166 8.04937 9.43191 -5.2183 +626 2 5.38812 11.3133 8.7152 -15.4132 0.789816 9.90132 +627 2 6.60546 10.8728 7.99206 7.62403 -6.5238 -2.76924 +628 1 2.80481 8.67956 0.357522 -16.6853 -5.97365 -15.2844 +629 2 2.27492 8.26466 18.2845 10.7138 4.85897 15.9492 +630 2 2.22127 9.36062 0.722932 4.52332 -2.29686 2.25001 +631 1 10.1103 10.3863 6.60128 -6.60242 -1.42487 -6.12592 +632 2 10.6136 9.70804 7.05871 2.40377 -4.05953 3.76861 +633 2 10.2954 10.2785 5.66001 4.13032 2.32994 2.59513 +634 1 6.85077 15.7563 6.70738 -11.7521 -4.07497 3.77538 +635 2 6.99262 16.2462 7.53077 3.71638 -1.24183 -4.26209 +636 2 6.92978 16.3894 5.98454 6.68147 0.141382 -0.214337 +637 1 6.48958 12.9529 5.78988 1.80967 -1.32299 -1.48619 +638 2 6.5811 13.8382 6.15183 4.24501 4.33378 1.70513 +639 2 6.11675 12.413 6.49523 0.159424 2.05888 1.44919 +640 1 16.7629 12.5191 9.71336 -1.62109 -11.3708 1.97787 +641 2 17.0324 11.8284 9.09183 -7.38478 2.50021 2.06117 +642 2 17.4395 13.1763 9.61316 3.98731 12.5093 -0.628579 +643 1 6.20997 2.89816 2.77935 -0.0802363 -5.63791 0.773513 +644 2 6.61167 3.74714 2.54082 -9.15989 -2.58724 -3.98308 +645 2 5.63039 2.60429 2.05445 8.60419 4.25286 3.07741 +646 1 10.7636 3.09526 3.23748 -2.12809 -1.19847 1.63085 +647 2 10.0581 3.70038 3.49376 4.9418 2.80865 -0.749542 +648 2 10.4122 2.60071 2.48751 -0.504171 1.44253 0.108713 +ITEM: TIMESTEP +80 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.8014 6.74321 17.9894 -25.71 0.163943 4.88408 +2 2 7.93592 6.85831 18.4426 18.3019 -2.2716 -9.29 +3 2 8.62145 6.12739 17.2721 4.06901 -0.284928 0.869098 +4 1 0.193099 8.36013 6.75275 5.74913 -14.5769 25.1987 +5 2 0.349094 8.05034 5.86501 -0.249861 0.708817 -17.2091 +6 2 0.558161 7.64099 7.32168 -7.5605 18.9357 -7.69302 +7 1 8.61156 0.29086 6.89037 18.8351 -6.84677 1.91716 +8 2 9.54524 0.192133 6.6105 -17.2936 6.40231 3.46958 +9 2 8.24205 0.986486 6.33979 -0.485036 0.67975 -2.4356 +10 1 6.46061 1.74084 11.7563 18.0716 -9.05138 -10.6926 +11 2 5.90902 2.36746 12.1907 -18.8993 15.6687 11.8916 +12 2 5.86943 1.07894 11.3852 -0.461453 -6.159 1.34784 +13 1 6.94761 5.53992 2.37529 -6.07193 26.0011 19.9509 +14 2 6.56484 5.89454 3.23997 6.76459 -12.0871 -41.8379 +15 2 6.81469 6.2225 1.67437 0.333839 -16.9501 17.8189 +16 1 16.2464 10.2212 16.095 -30.9636 -1.96085 19.7441 +17 2 16.8891 10.4896 15.4774 30.9665 9.88757 -18.0257 +18 2 15.7638 11.031 16.3423 6.62567 -11.9253 -3.68232 +19 1 10.7594 14.9468 2.28506 -10.192 -15.3258 -5.27915 +20 2 10.552 14.3194 2.98639 5.50444 -0.296801 2.35986 +21 2 11.1642 15.6696 2.7411 11.3222 17.7739 6.10774 +22 1 17.1862 8.22111 10.8759 16.4539 0.643281 -9.91552 +23 2 16.576 8.81969 11.3105 -3.64966 6.67804 4.28607 +24 2 17.949 8.77387 10.614 -8.44523 -5.92405 1.0378 +25 1 14.6358 16.0024 16.3895 25.5058 -11.0228 4.42293 +26 2 13.7352 16.2786 16.3126 -22.3429 5.97271 0.576342 +27 2 14.7081 15.5263 17.2386 -3.54281 4.69451 -12.0743 +28 1 12.1273 13.3164 0.564829 -0.361627 4.24339 0.0908299 +29 2 11.7754 13.443 18.3303 1.85705 -5.04776 -15.4247 +30 2 11.6653 13.9884 1.07404 2.42612 -1.45379 10.2607 +31 1 9.30563 5.48822 3.87958 6.5447 0.0363683 25.4904 +32 2 8.87806 5.40536 4.77034 1.54217 -0.907852 -25.4465 +33 2 8.62277 5.52424 3.19838 -5.81373 -1.17005 3.72822 +34 1 1.59219 3.96918 11.5778 -9.84269 42.1113 -23.7424 +35 2 1.65598 4.94531 11.7448 -5.32168 -23.4604 1.30407 +36 2 2.08682 3.52502 12.2368 16.8537 -14.859 24.6718 +37 1 2.0876 6.92307 8.18563 -3.73767 -8.57072 -0.0346284 +38 2 2.39381 7.30463 9.00964 5.23298 7.68032 1.6714 +39 2 2.09597 5.97338 8.35948 -3.7573 0.82597 0.238295 +40 1 5.28961 4.49122 7.85762 -5.23337 8.41869 1.15392 +41 2 5.42981 3.54006 7.92701 -4.09922 -6.37036 -7.26013 +42 2 4.64396 4.70759 7.15783 7.0556 -5.183 4.67383 +43 1 3.36027 2.89954 17.3915 -17.4395 12.4687 22.0366 +44 2 4.05476 3.43419 17.006 5.24509 0.828911 -8.29254 +45 2 2.77379 3.5226 17.8911 18.871 -11.3769 -11.5396 +46 1 7.49453 5.42535 6.18785 1.1565 -0.337813 22.5495 +47 2 7.9164 5.96716 6.90215 -9.87324 -14.4944 -23.4171 +48 2 6.89327 4.79051 6.63979 12.0833 17.318 -7.46699 +49 1 9.81909 7.02563 12.0706 7.31099 -1.858 8.99458 +50 2 10.1534 6.27284 11.5881 4.21769 -4.6772 -1.38273 +51 2 9.09614 7.33889 11.5389 -11.6555 6.63577 -10.586 +52 1 13.987 3.72336 8.09074 -16.8343 16.962 -37.2017 +53 2 13.5442 4.52839 7.7245 12.4076 -19.615 9.33911 +54 2 14.2201 3.91921 8.97962 7.00657 7.67382 26.2916 +55 1 4.5104 17.1281 3.91533 10.7578 31.6451 -21.4766 +56 2 5.3439 17.6347 3.91183 -5.56531 -14.4645 11.3324 +57 2 4.01019 17.58 3.20396 0.717673 -14.6313 13.083 +58 1 16.3456 16.5752 10.4878 9.47486 -6.83722 -28.8723 +59 2 15.5139 16.524 10.9378 -17.3385 1.90191 12.1775 +60 2 16.1667 16.1386 9.62748 3.54118 4.50203 14.5107 +61 1 1.9669 4.78352 0.127126 -0.739304 -4.30462 13.1261 +62 2 2.4124 5.1813 0.904759 -4.07407 -0.50297 -16.3737 +63 2 1.70825 5.48663 18.1668 4.40273 7.87995 3.28325 +64 1 11.3312 13.2592 16.4181 -1.15069 -16.7597 -15.9919 +65 2 10.8158 12.4247 16.4648 10.4615 17.429 3.38388 +66 2 11.9137 13.1122 15.6483 -5.75273 4.84583 10.0297 +67 1 10.0951 10.9476 16.7865 12.4257 -21.5163 1.40398 +68 2 10.4762 10.0399 16.7888 -6.98476 25.4172 2.00859 +69 2 9.15392 10.8219 16.7533 -12.5538 0.302602 -1.38706 +70 1 11.8287 17.486 13.4829 -0.118354 -13.6364 7.15806 +71 2 12.4458 16.8683 13.0504 -5.40922 13.24 -3.88075 +72 2 12.1685 18.3769 13.3708 4.2975 6.3924 -3.60834 +73 1 6.40329 9.45666 12.3007 7.59953 -15.5921 -26.3915 +74 2 7.02951 9.14458 11.6116 -13.6176 6.52201 11.0115 +75 2 6.95635 9.88774 12.9378 9.38595 10.7935 13.1394 +76 1 16.3024 12.9052 2.74142 -15.9403 -16.7132 8.77179 +77 2 17.1501 13.3041 2.5727 9.16723 7.57391 -3.15506 +78 2 15.6647 13.6204 2.85813 1.6204 2.22565 -2.39426 +79 1 0.760847 12.751 5.87222 -24.7031 -12.948 -13.3423 +80 2 1.12648 12.6956 4.9713 -1.82207 2.12621 9.26767 +81 2 18.4428 12.5289 5.74368 26.1358 12.2861 6.31515 +82 1 5.29492 16.3822 18.4146 -5.77927 -1.1636 -2.25588 +83 2 5.45161 15.4933 18.0434 4.5004 13.3336 10.181 +84 2 5.72207 16.4863 0.6292 0.349856 -6.54957 -3.00829 +85 1 0.672446 7.71977 4.17015 11.9206 5.83738 -2.65809 +86 2 0.0599114 7.99601 3.47788 2.17241 0.0211014 0.560686 +87 2 1.51354 8.18303 3.96741 -13.409 -12.9126 0.0558484 +88 1 3.18041 9.04016 6.47644 -48.733 9.26031 0.132627 +89 2 3.67612 8.69495 7.19851 13.8171 -10.3779 15.348 +90 2 2.22175 8.86945 6.71565 32.4894 5.10639 -10.1715 +91 1 7.33809 10.425 16.1982 -13.7714 -1.76245 23.4597 +92 2 6.52669 10.798 15.8343 6.52641 -1.5478 0.375626 +93 2 7.11414 10.2397 17.1395 3.58358 2.1532 -21.3577 +94 1 11.0368 0.910412 5.00755 -5.03762 -2.37072 -20.9965 +95 2 11.0166 1.76948 4.5572 3.99116 -0.122414 9.27702 +96 2 10.8085 0.318039 4.26499 2.41704 1.78329 12.9529 +97 1 4.27055 2.90822 13.1584 -5.03414 2.69466 11.7405 +98 2 4.39065 3.48249 13.9384 2.16314 -12.4788 -5.29849 +99 2 4.11656 2.00207 13.4974 4.2297 10.0998 -5.7581 +100 1 8.47529 10.248 1.79037 -0.416679 -17.2671 7.19176 +101 2 8.23967 10.8662 2.49257 2.8179 1.08296 2.51337 +102 2 8.59639 9.37915 2.23271 0.0130336 16.1865 -5.8343 +103 1 10.3383 1.70852 15.4843 -18.7352 2.46602 -2.29408 +104 2 11.1863 1.36274 15.7269 17.9639 -3.17473 -1.31836 +105 2 10.261 1.74525 14.5183 4.02029 2.26456 4.98686 +106 1 2.61381 12.97 7.91629 0.377646 -9.00714 -10.2558 +107 2 3.20736 13.521 7.38885 -1.73045 4.27865 2.80704 +108 2 1.92972 12.6563 7.30106 5.76016 2.06086 0.889789 +109 1 3.8265 11.6489 4.94253 -18.049 0.292651 15.0893 +110 2 3.64515 11.1228 5.74952 0.240622 6.04317 -17.8646 +111 2 3.00147 11.7074 4.41136 14.7829 -0.870145 11.9003 +112 1 6.67003 14.5068 16.9871 0.195301 -8.52391 -8.20479 +113 2 7.30673 15.1853 17.2075 3.81359 1.00594 1.02421 +114 2 6.51415 14.5784 16.0351 -3.74805 4.58221 3.23833 +115 1 14.2005 14.4991 3.2542 12.2104 -4.1759 -13.149 +116 2 13.9664 15.4191 3.35064 -8.52353 7.22912 -0.280994 +117 2 13.8358 14.0368 4.00136 -6.61808 -5.66537 10.7242 +118 1 8.64986 18.0488 16.0994 -35.3958 -9.60596 -0.188096 +119 2 9.08138 17.255 16.4541 14.3634 13.9351 -5.51429 +120 2 9.16615 0.19969 15.9552 18.9441 -0.541676 3.30098 +121 1 4.69447 1.75392 4.88991 25.859 26.3088 -12.7751 +122 2 3.87089 2.24691 4.93296 -3.58784 0.203107 2.94233 +123 2 5.32887 2.35869 4.40805 -22.2668 -23.8988 10.2256 +124 1 15.0337 12.5563 16.5322 -9.42235 19.0778 45.1845 +125 2 14.5415 12.8308 17.3429 25.2588 -5.91919 -13.7907 +126 2 14.3516 12.6025 15.8912 -15.7131 -4.7436 -33.7881 +127 1 15.7107 18.4933 16.8499 14.0119 15.6823 26.0515 +128 2 16.2364 18.5256 17.6977 -11.7154 -4.95338 -28.5838 +129 2 15.2517 17.6535 16.8181 2.70767 -12.4638 1.72062 +130 1 1.36288 1.31672 16.6317 -8.11361 12.6727 12.78 +131 2 2.12452 1.88684 16.8387 -7.41596 -12.3761 -6.73343 +132 2 0.666274 1.64987 17.2352 10.0682 -8.10993 -10.4284 +133 1 18.2119 4.36953 15.9172 -1.70541 -5.24792 -22.7614 +134 2 17.9042 3.81192 15.1707 6.44647 9.66147 16.3107 +135 2 0.476259 4.62247 15.7042 -5.76089 -2.38794 2.9761 +136 1 12.1484 17.0613 16.1489 -25.1744 -26.2572 32.1897 +137 2 11.4087 16.4938 16.5203 28.1495 25.8696 -8.33389 +138 2 11.9925 17.0682 15.2174 -4.06343 5.18838 -23.7308 +139 1 16.1307 2.63053 18.236 -24.4255 7.46546 -12.7341 +140 2 15.654 3.45006 18.4862 10.3096 -12.6534 -4.96798 +141 2 15.8825 2.42572 17.3162 0.942238 5.76458 9.76029 +142 1 6.69125 13.7819 10.0957 6.51523 5.30674 14.72 +143 2 6.68166 13.4115 10.9958 -3.31201 0.605957 -8.104 +144 2 6.74207 13.0463 9.48799 -5.76864 -9.77159 -4.40801 +145 1 10.1909 18.4566 2.69612 24.6552 12.5235 -11.9688 +146 2 10.5208 0.299966 1.90483 -6.63917 -6.88653 20.5003 +147 2 9.33855 18.1401 2.45819 -23.0922 -9.86885 -6.30041 +148 1 3.05041 17.6833 6.1612 -20.7399 0.346779 9.3758 +149 2 2.11766 17.6882 5.81771 32.7543 -5.44367 1.96306 +150 2 3.663 17.6288 5.4193 -6.60477 0.357372 -5.21379 +151 1 12.6301 16.8021 7.91443 2.73044 3.22351 -7.20597 +152 2 11.8394 16.2829 7.68186 3.48899 3.70212 12.2186 +153 2 12.4619 17.4281 8.63963 -10.075 -5.48551 -5.536 +154 1 14.8863 15.2402 8.20999 -23.6436 14.8183 29.3151 +155 2 14.1404 15.8836 8.27066 14.7388 -14.8318 -6.56535 +156 2 15.2763 15.3549 7.35467 9.52302 6.19548 -12.651 +157 1 17.8321 18.2493 0.273835 -34.2521 -9.59248 -4.32979 +158 2 18.5224 17.6645 -0.0392514 10.753 2.02465 3.4369 +159 2 18.2087 0.412934 0.595185 14.0613 13.0178 4.00109 +160 1 0.763956 10.5262 1.39925 -10.0074 -57.9186 33.1602 +161 2 0.0205775 9.86382 1.5781 27.9288 29.6193 -5.5527 +162 2 0.446448 11.1766 0.811593 -14.5912 25.5328 -23.4764 +163 1 1.80037 12.2889 3.30512 5.17734 11.597 19.2466 +164 2 1.46139 11.5987 2.74824 -6.10095 -9.75588 -16.5262 +165 2 2.13675 13.0044 2.75129 -3.9772 -2.70365 -1.85909 +166 1 0.682885 17.2588 4.99366 18.5034 24.5267 -32.7679 +167 2 0.107172 18.0117 5.16246 -8.54671 -5.12892 6.2039 +168 2 0.50047 16.4742 5.48014 -13.5055 -14.6224 21.6265 +169 1 1.0645 0.823506 9.34737 11.8193 5.83131 5.68962 +170 2 1.36557 0.594309 10.2448 -8.52979 0.55273 -0.975829 +171 2 0.153783 0.559257 9.28231 -13.2671 -5.76719 2.40467 +172 1 16.771 2.35127 13.3608 4.58635 29.8799 -13.6101 +173 2 16.8279 2.7166 12.4388 1.57782 -15.3367 24.752 +174 2 16.4858 1.44141 13.3191 -2.28737 -11.3359 -2.05688 +175 1 2.68433 15.9539 12.0479 2.00481 -8.12072 21.99 +176 2 2.97356 15.5639 12.9056 -4.45908 8.74231 -22.8774 +177 2 3.1524 15.4962 11.3314 -4.16555 3.83231 7.28649 +178 1 16.3902 15.5703 6.15458 18.8333 21.1033 -24.533 +179 2 17.3221 15.5371 6.43733 -15.6071 -4.56317 -0.523174 +180 2 16.3697 16.3474 5.53712 -7.15193 -24.3314 15.8574 +181 1 5.78808 5.16844 11.811 1.07675 -5.38543 -7.05048 +182 2 5.68145 6.03537 12.2081 -3.48533 4.06917 4.5041 +183 2 5.0592 4.65006 12.1655 2.16361 -4.54815 -2.94322 +184 1 15.172 4.89144 0.795633 -0.620892 -0.594882 26.39 +185 2 14.9156 4.81116 1.75201 7.19669 -4.64536 -26.7766 +186 2 14.3985 5.20255 0.336699 -8.8444 5.20324 -3.46854 +187 1 16.3986 16.4119 1.90339 15.122 14.6556 -26.5352 +188 2 16.0454 16.7612 2.71133 -6.27107 5.29423 17.303 +189 2 16.8063 17.1873 1.44657 -8.45441 -18.3773 8.08233 +190 1 0.184762 4.82044 3.92309 -20.0167 36.2337 -7.4234 +191 2 0.305381 5.80234 3.92557 1.42835 -23.0136 0.864842 +192 2 1.01251 4.4465 4.18098 17.0496 -9.16948 9.65169 +193 1 2.95853 15.072 15.1235 -0.929158 -18.0667 1.08146 +194 2 2.81752 14.526 15.9315 -1.93517 21.6459 -9.19578 +195 2 2.47159 15.9015 15.2035 -0.281788 -0.150795 8.17547 +196 1 1.08884 14.6409 9.4443 27.3966 -12.5379 -34.1186 +197 2 1.70575 13.947 9.05916 -23.9186 28.888 17.798 +198 2 0.66831 14.2301 10.1769 -7.64803 -12.9163 21.0233 +199 1 13.5173 16.5215 11.5364 0.489599 15.4909 -5.38356 +200 2 13.0836 17.2895 11.1076 8.88627 -7.75363 7.54599 +201 2 13.0704 15.7764 11.1287 -2.36322 -6.26123 2.87696 +202 1 4.73898 1.52078 0.69167 -9.68217 -10.6702 17.6377 +203 2 4.07875 2.00526 0.184075 4.46446 1.98443 -3.98397 +204 2 4.22033 0.928191 1.27988 9.48282 8.28471 -14.387 +205 1 1.52478 18.5784 11.9214 -16.2358 21.4234 -4.1613 +206 2 1.51367 0.493465 12.7143 -0.730917 -3.29007 -5.80239 +207 2 2.22048 17.951 12.0321 13.8924 -17.5303 6.45556 +208 1 11.4148 10.1041 4.08036 9.63761 14.6797 -7.17105 +209 2 11.6092 10.6619 3.28786 -9.14527 -18.7957 16.2306 +210 2 12.2661 9.96891 4.5224 -0.931524 1.73008 -8.63915 +211 1 8.18373 12.2132 3.70486 4.04638 8.18109 41.2935 +212 2 9.0456 12.58 3.98139 -6.62274 -6.35725 -9.04284 +213 2 7.64552 12.2934 4.54 8.66084 -3.68417 -28.5646 +214 1 14.5934 4.00277 3.33714 14.4882 6.32576 -0.110592 +215 2 15.3087 4.27672 3.93937 -11.245 -6.6719 -0.591331 +216 2 13.7777 4.36055 3.68688 -6.37652 3.17854 3.04506 +217 1 5.71814 1.6621 7.57513 -5.5313 -4.02265 40.0153 +218 2 5.00295 1.12677 7.97081 8.59667 7.25176 -1.51046 +219 2 5.48447 1.71188 6.6706 -7.03261 -0.519715 -37.0679 +220 1 17.8819 0.996597 4.84385 3.28334 1.22129 -8.70029 +221 2 18.3735 1.40853 4.10428 -5.78677 -2.02928 14.9184 +222 2 17.7642 1.64161 5.55539 2.20556 -0.0657175 -7.03701 +223 1 6.81886 9.28778 4.52861 6.25722 -6.76526 -10.2791 +224 2 6.61832 9.39383 5.45723 -0.00817066 1.76549 8.49843 +225 2 7.7574 9.04758 4.4954 -4.05712 -0.0763234 -2.03313 +226 1 2.4854 14.759 2.04442 -7.64745 -7.92423 -28.9185 +227 2 3.31932 14.7218 2.51092 7.63377 -1.04104 5.23896 +228 2 2.65881 14.5612 1.09422 1.17207 5.04057 23.1132 +229 1 17.2643 12.9213 13.1026 -19.9619 15.9168 2.25648 +230 2 16.3761 13.2301 13.4207 25.7036 -1.66639 -12.6722 +231 2 17.7779 13.7212 12.8621 -11.3949 -9.92691 5.05246 +232 1 14.8558 10.5579 1.44832 -24.1837 -11.6243 -0.0449549 +233 2 15.2498 11.3496 1.79784 9.85962 12.147 5.79114 +234 2 13.9164 10.5877 1.7065 14.7293 1.68269 -5.02708 +235 1 5.67033 6.62258 4.57309 8.95784 -16.3381 4.76769 +236 2 5.78141 7.53495 4.33529 5.34224 19.3995 0.612293 +237 2 6.44538 6.37316 5.11369 -12.1071 3.69782 0.132968 +238 1 8.08484 8.3464 10.3723 -2.79238 1.81559 10.704 +239 2 8.60215 8.86766 9.74634 -1.18548 0.238269 1.84293 +240 2 7.34937 7.94467 9.9053 0.580319 -4.15939 -10.1337 +241 1 13.4382 18.465 5.66883 -2.12963 -16.204 3.95429 +242 2 12.6402 0.317353 5.43723 -0.0049589 1.74147 2.86213 +243 2 13.1409 17.7635 6.28441 4.99057 13.7489 -2.35078 +244 1 -0.0389125 2.60201 0.358484 20.6019 -11.619 5.06808 +245 2 17.6744 2.57403 18.7483 8.04315 12.368 -1.45646 +246 2 0.347515 3.47455 0.194182 -8.07269 -1.54831 -1.2857 +247 1 12.9609 10.9078 9.72363 -44.1168 29.5082 -8.54535 +248 2 11.9486 10.9818 9.7709 44.2995 -10.8859 -2.13595 +249 2 13.1901 10.0051 9.91101 -8.5598 -18.2315 3.87517 +250 1 0.590645 12.1909 11.1498 11.7969 16.2942 20.6903 +251 2 18.3214 12.2032 11.4307 -13.062 -2.39731 -5.9775 +252 2 1.05781 12.4788 11.9545 1.3761 -3.96073 -11.1532 +253 1 5.19979 7.35251 13.3459 4.96104 -3.5954 0.621761 +254 2 5.77554 8.05147 13.0099 -6.36891 3.58923 -1.12306 +255 2 5.62026 7.07364 14.1664 0.643961 -0.709679 0.08133 +256 1 1.17273 6.78721 11.9743 -37.7935 -22.2758 -19.6174 +257 2 0.361865 7.16229 11.5551 20.1673 -8.51661 10.9701 +258 2 1.7013 7.51605 12.2195 19.7686 31.2325 8.39364 +259 1 15.5313 9.74152 12.3525 -7.42661 26.8763 14.1834 +260 2 15.1354 10.6339 12.1691 17.2848 -32.3992 2.44097 +261 2 15.9001 9.83422 13.2442 -4.7827 -6.0868 -10.0384 +262 1 16.5842 12.6457 5.58229 -7.58554 26.2756 -26.1768 +263 2 16.3849 13.5701 5.8413 5.71516 -14.5282 0.0223018 +264 2 16.4193 12.6729 4.60395 6.10391 -10.0799 23.5706 +265 1 6.38601 9.81704 0.0456579 -23.7849 0.890546 -8.41533 +266 2 5.51671 10.1854 0.278669 9.54818 -0.234306 -0.813632 +267 2 7.00687 10.1562 0.67255 15.5644 7.03716 17.2844 +268 1 12.2684 6.05846 4.00919 -28.2934 -33.3926 21.5663 +269 2 12.263 6.7861 3.41661 0.234348 22.4834 -18.769 +270 2 11.3224 5.76736 4.06199 25.4812 4.82389 -2.50319 +271 1 0.373791 12.8792 0.072054 -11.107 3.80906 -1.77299 +272 2 18.9015 13.5268 0.779758 -5.73011 -3.33995 1.31101 +273 2 18.3694 13.1354 18.0395 6.43374 -1.82904 2.53089 +274 1 3.55692 18.7013 8.65073 14.893 -16.0199 -12.5754 +275 2 3.38339 18.1698 7.85699 7.36237 7.58391 1.53928 +276 2 2.68044 0.23403 8.96368 -11.3363 8.83032 5.06178 +277 1 7.32525 17.3963 4.4514 17.4309 29.7426 -3.23332 +278 2 7.82401 18.2131 4.74166 -23.0386 -26.7058 -8.39786 +279 2 7.43189 17.3694 3.48275 -1.39589 -2.42936 11.5599 +280 1 9.26525 17.1572 12.169 8.13396 -3.40366 20.592 +281 2 9.29678 16.2438 11.8433 -0.925088 7.81756 -3.33389 +282 2 9.96734 17.2329 12.8546 -10.0311 -2.0771 -17.5408 +283 1 13.2786 13.1508 8.01112 -12.5044 -28.1533 13.0431 +284 2 13.4287 12.5256 8.7581 -3.83031 10.1919 -19.0767 +285 2 13.9208 13.8439 8.10408 14.3758 9.62768 2.82629 +286 1 14.7717 2.95063 15.4663 23.0059 6.37496 -12.5686 +287 2 14.1149 2.31 15.1961 -5.56432 -5.96018 -2.11564 +288 2 15.3514 3.08539 14.6861 -8.35989 -8.63193 12.4086 +289 1 9.95789 15.6422 16.9764 -4.46993 0.793564 -8.8018 +290 2 10.2307 14.8148 16.5569 1.31144 -2.42354 4.42353 +291 2 9.44172 15.4 17.7473 1.0906 -3.95706 9.45227 +292 1 11.2531 8.54113 16.6333 5.17657 0.0418295 -8.84929 +293 2 10.6325 8.00272 16.1399 -5.6117 -5.11655 -0.169214 +294 2 11.5912 7.9918 17.3372 0.751532 -6.83429 5.96975 +295 1 4.09617 18.2775 16.8038 -1.75476 28.7193 2.74196 +296 2 4.5979 17.7227 17.3968 3.26159 -10.0112 3.6984 +297 2 4.13851 0.526798 17.2077 -3.53746 -18.1625 -9.44923 +298 1 2.30039 4.26982 8.91686 21.6694 -5.11589 23.5763 +299 2 3.26852 4.19272 8.75344 -21.2665 0.643644 3.82423 +300 2 2.17319 4.0769 9.88449 2.25335 4.47185 -28.5355 +301 1 9.91449 10.4045 9.82138 -1.36818 12.3774 -23.5261 +302 2 9.54718 11.2486 9.48103 5.13969 -13.6804 7.80682 +303 2 9.93694 10.4191 10.7736 0.214264 3.33848 13.7587 +304 1 9.74784 0.927945 10.8307 17.8645 8.52415 0.395599 +305 2 9.30432 0.217271 11.2949 -5.1784 -7.81016 -3.03012 +306 2 9.13824 1.32484 10.1982 -3.45577 -3.9008 2.04599 +307 1 9.17195 15.1281 10.2005 -15.5022 -1.44929 -2.09464 +308 2 8.96814 15.9769 9.77108 -2.08214 -7.76738 2.59404 +309 2 8.35001 14.5895 10.1068 18.2617 13.451 2.66111 +310 1 0.828362 9.74081 10.2167 22.8302 -4.53826 -35.6406 +311 2 0.863435 10.6794 10.4661 0.846835 -12.3508 -3.07098 +312 2 1.42185 9.63122 9.40918 -26.8549 6.26386 38.0517 +313 1 17.1622 4.86379 8.08044 2.41554 -11.1764 16.204 +314 2 16.3163 5.29453 8.26848 4.74994 -0.845127 5.21041 +315 2 17.4172 4.31929 8.8662 -8.72341 14.5987 -22.1578 +316 1 14.8039 14.6747 0.0449816 -17.091 -7.62196 19.0468 +317 2 15.3137 15.169 0.695817 3.50252 1.08273 0.82912 +318 2 14.0068 14.3765 0.533797 12.6241 2.78049 -10.2188 +319 1 3.85026 11.0642 9.5563 -2.44831 7.24975 -16.8488 +320 2 3.90516 11.4403 10.4374 -3.64435 1.57263 7.30128 +321 2 3.45144 11.7342 8.96857 -1.60708 -4.46554 10.9787 +322 1 11.3552 10.7376 1.50363 23.7004 17.8717 -7.90317 +323 2 11.5499 11.5913 1.05012 -4.60225 -16.5984 9.56505 +324 2 10.4091 10.6312 1.49605 -14.4596 -0.264671 -3.06241 +325 1 13.1456 7.20328 12.6021 -24.9249 -2.39855 5.22786 +326 2 14.066 6.96941 12.5913 17.2615 -6.20786 -1.13088 +327 2 12.6433 6.37391 12.7221 9.22616 8.00521 -2.5813 +328 1 9.63635 1.93928 0.908954 12.9918 3.25798 9.3487 +329 2 8.80616 1.72326 0.497356 -10.689 -0.461065 -8.23177 +330 2 10.2384 2.2422 0.224542 -0.105661 1.67982 -4.44056 +331 1 10.6547 13.4406 4.52244 4.65594 3.65244 26.3326 +332 2 11.5391 13.0824 4.73514 -13.2197 2.26822 -8.08889 +333 2 10.4444 13.96 5.32492 0.722291 -5.69425 -12.9779 +334 1 14.5068 1.61853 10.9473 1.56188 14.5139 4.90111 +335 2 15.3059 1.27791 10.528 -0.453964 2.70191 1.23402 +336 2 14.6742 2.57144 11.1203 -1.66622 -13.4066 -10.2612 +337 1 14.4999 12.0198 11.6401 -20.4 4.4823 -10.6844 +338 2 15.1901 12.5044 11.1683 0.00955556 -6.20474 -4.10181 +339 2 13.88 11.6279 10.9736 17.9431 15.8984 14.8698 +340 1 8.17874 5.12415 9.82106 -30.5984 10.5693 18.9492 +341 2 7.28241 5.07355 10.2519 27.6442 5.22023 -11.9731 +342 2 8.30253 4.26697 9.4335 2.62166 -17.6444 -4.58757 +343 1 1.47714 16.9429 18.4887 13.3148 33.7663 -28.6254 +344 2 1.86682 17.2437 17.6257 -9.89818 -8.00998 25.1444 +345 2 1.74527 16.0479 18.574 6.31239 -26.8006 -0.778427 +346 1 1.45374 17.3594 15.3268 42.8952 -1.15706 -0.811193 +347 2 1.42588 18.2136 15.749 -3.30828 11.7666 5.73369 +348 2 0.584657 17.0429 15.2318 -41.4551 -8.54136 -0.705167 +349 1 3.54007 5.76039 6.04888 -8.98595 6.80975 7.90297 +350 2 3.01039 6.43039 6.5207 7.85999 -10.8756 -2.65394 +351 2 4.1622 6.27284 5.52252 1.18276 -3.83664 -2.43702 +352 1 12.5413 9.50789 14.2278 14.1386 -34.2774 -1.94842 +353 2 12.9806 8.74877 13.7665 -10.1246 23.4373 5.48687 +354 2 12.3781 9.12309 15.104 -2.49329 10.5308 -3.54938 +355 1 4.07791 15.2392 7.05947 28.2061 -4.52306 7.60827 +356 2 3.62905 16.0551 6.82 -1.6925 3.55103 -3.37365 +357 2 5.05246 15.4367 7.04645 -25.4492 -3.49557 -3.60676 +358 1 0.767125 8.74429 15.1186 -1.35051 -1.02403 -4.71838 +359 2 0.502685 9.67668 15.1423 2.70563 -3.13172 -3.80763 +360 2 1.44028 8.65803 14.4206 -5.36892 5.64782 6.7911 +361 1 12.8556 8.29114 10.1154 40.5883 -11.1151 11.7349 +362 2 13.7543 7.93714 9.90509 -23.2563 4.30646 -4.77873 +363 2 12.8036 8.10553 11.059 -7.7965 -1.57596 0.639248 +364 1 15.3061 7.91627 3.47282 -42.6646 -27.0181 14.5138 +365 2 14.4087 7.67951 3.19876 7.83283 16.2655 -25.9683 +366 2 15.288 7.37548 4.27198 30.0578 14.5578 6.00353 +367 1 17.2193 6.75387 0.0348868 -24.2654 8.60155 -9.76068 +368 2 16.7331 5.97981 0.339573 3.08011 -1.47023 2.02216 +369 2 16.4984 7.35116 18.3587 20.6605 -10.5931 7.39935 +370 1 8.96527 6.96977 7.82312 -33.6536 -16.7811 13.5927 +371 2 9.86459 7.23854 7.79988 29.8916 7.79708 0.58286 +372 2 8.85329 6.36072 8.58482 2.84704 12.8992 -8.98126 +373 1 12.4369 0.615517 1.24835 5.12967 -8.6669 -10.2958 +374 2 13.1996 1.14046 1.50868 5.63 -3.81589 5.32704 +375 2 12.6841 0.248493 0.387703 -6.12727 4.87774 5.89397 +376 1 5.63437 15.0947 14.482 15.2573 18.1506 -1.5187 +377 2 4.74012 15.1756 14.8216 -5.87791 -1.19647 -0.853033 +378 2 5.96659 16.0211 14.4028 -4.19512 -21.3346 -4.32131 +379 1 3.78146 6.44452 1.71439 -10.0957 17.3086 -10.1533 +380 2 3.36154 7.20469 1.26344 3.84289 -8.07011 2.3383 +381 2 3.80108 6.73559 2.62781 1.97525 -3.80667 6.02801 +382 1 3.89131 11.3886 12.3597 10.4858 -4.45626 -8.95185 +383 2 4.75702 11.7925 12.5217 -6.56671 -1.88331 -0.935479 +384 2 3.25208 11.9718 12.7596 -7.39976 8.19237 6.18945 +385 1 5.30831 3.87649 15.7567 -11.2019 61.1278 12.0088 +386 2 6.01892 3.27998 15.6709 29.6235 -28.0721 -9.85567 +387 2 5.7476 4.76544 15.8793 -15.8563 -28.9516 -7.19779 +388 1 14.1175 10.173 4.66017 9.40425 -19.9217 -33.2768 +389 2 14.1461 9.82294 5.54158 6.86029 -3.38102 17.8715 +390 2 14.6328 9.51646 4.11155 -16.0552 24.3993 16.1239 +391 1 7.5636 17.329 9.02789 1.81886 -5.76611 4.78707 +392 2 6.9813 17.6417 9.74433 4.383 2.36677 -11.0761 +393 2 7.91242 18.0661 8.5041 -5.60089 1.56926 3.7162 +394 1 4.54646 14.4437 3.82391 2.35855 8.70422 24.1238 +395 2 4.58695 15.3758 4.17596 -1.73775 -31.732 -9.36156 +396 2 4.50325 13.8127 4.58585 2.14298 18.0212 -18.4803 +397 1 14.2437 7.3639 15.8726 24.9361 2.31774 6.81444 +398 2 15.0991 7.30759 15.3921 -17.5628 0.546592 9.39404 +399 2 14.5002 7.74932 16.7373 -8.89015 -4.19374 -15.8798 +400 1 3.04207 18.4209 1.96748 -18.4085 17.9201 24.7102 +401 2 2.5353 17.8449 1.40649 -4.22111 -10.717 -13.4847 +402 2 2.35407 0.262093 2.48798 16.8127 -9.3976 -15.4809 +403 1 7.96924 1.62215 4.56344 31.9424 -9.467 0.421552 +404 2 7.35201 1.92948 3.90341 -1.64239 4.88827 -11.6355 +405 2 8.85795 1.52282 4.13815 -26.2226 6.52533 8.08337 +406 1 2.457 14.1626 17.6995 -18.6259 -8.83368 10.0969 +407 2 1.68725 13.6009 17.9701 23.9808 13.2635 -8.93306 +408 2 3.24279 13.6711 17.9492 9.2771 -5.34798 1.51385 +409 1 0.927142 1.91914 13.8849 28.4694 2.81528 -14.4963 +410 2 1.17928 1.66855 14.7668 -1.31862 -2.11333 16.1229 +411 2 -0.00784116 2.01924 13.8762 -26.8609 -0.0423979 -2.90492 +412 1 4.3639 0.116891 13.871 19.5154 5.98388 -10.2249 +413 2 5.3312 18.592 13.8382 -18.25 -1.84578 0.0905254 +414 2 4.09014 18.5553 14.7613 -1.68072 -4.35498 12.29 +415 1 7.32185 0.935992 18.4254 -25.1976 4.88188 40.3736 +416 2 7.29261 0.583526 17.5599 3.22929 -13.7772 -30.1977 +417 2 6.39141 0.906009 18.7671 22.6248 8.40202 -10.9225 +418 1 15.9043 18.3822 13.9598 -30.4853 6.92778 -31.02 +419 2 14.9691 18.5865 13.6701 32.1757 -7.76669 18.1984 +420 2 15.9697 -0.290473 14.9111 -4.96086 4.78357 11.6174 +421 1 10.2566 4.62301 16.2429 -20.4053 -21.3362 -19.7333 +422 2 11.1923 4.47268 16.3843 6.75918 3.74651 0.0845893 +423 2 9.94726 3.80759 15.7722 8.97755 19.5704 18.0095 +424 1 15.9188 17.665 4.49409 -30.8876 16.8748 5.69015 +425 2 16.5463 18.3904 4.38809 -0.624131 1.21894 5.03495 +426 2 15.0755 18.0798 4.84388 28.6139 -15.2662 -13.1828 +427 1 6.9464 17.5119 13.903 30.1459 16.134 14.6047 +428 2 7.45538 17.7973 14.7126 -14.438 -11.5296 -22.8133 +429 2 7.62564 17.4897 13.1926 -14.0494 -3.94126 11.1274 +430 1 13.2241 6.43487 6.53037 -11.3028 -4.49966 -3.41689 +431 2 14.1722 6.56035 6.47079 5.41657 3.67276 -3.81812 +432 2 12.8747 6.35097 5.62176 7.42053 0.356932 11.8509 +433 1 7.85865 2.26615 9.45505 -4.28533 -3.16859 -37.0089 +434 2 7.29966 2.29372 10.2234 -12.0252 -4.85104 14.2867 +435 2 7.31757 1.89726 8.71059 11.6806 10.5906 18.7024 +436 1 15.1499 14.8389 13.7285 -7.78284 7.72319 0.275575 +437 2 14.8617 14.9509 14.6481 -0.524909 3.36892 -5.65775 +438 2 14.6832 15.507 13.1912 6.48748 -10.1003 7.43034 +439 1 9.39784 8.36731 3.82962 2.5344 -9.0015 0.237957 +440 2 10.2136 8.88179 3.87227 -2.41531 -0.25237 0.330419 +441 2 9.66909 7.4454 3.98022 -9.00345 8.8328 -4.59515 +442 1 17.7291 13.5977 16.4646 5.88425 13.7422 -6.32319 +443 2 16.779 13.4368 16.4502 -3.47507 3.66531 -1.64514 +444 2 17.9175 14.4327 15.9665 -10.227 -20.4783 11.0606 +445 1 4.89529 10.4518 2.85531 35.8078 -15.8912 -9.72696 +446 2 5.76001 10.066 3.12945 -20.0856 5.21459 -7.60385 +447 2 4.65599 10.9551 3.62329 -7.19184 9.4675 7.77805 +448 1 3.68184 8.40606 9.96257 -7.06038 -13.6752 25.4145 +449 2 3.73025 9.3314 9.75201 2.05841 13.8137 -4.67922 +450 2 3.5201 8.39907 10.9276 1.35511 -1.83367 -14.7667 +451 1 15.9506 6.91676 5.90036 8.23349 -12.8437 -5.59708 +452 2 16.7283 7.39089 6.23923 -5.44721 -6.23743 -4.31526 +453 2 16.2459 6.04307 5.54881 -4.37327 20.9496 12.2757 +454 1 15.2047 7.21919 9.02648 -8.23364 16.7266 -25.0777 +455 2 16.0013 7.62239 9.37026 6.97324 -0.496136 10.989 +456 2 14.9764 7.76869 8.23928 2.79192 -13.8116 16.1423 +457 1 6.18989 12.8346 12.7303 -2.33267 17.6694 7.57139 +458 2 6.82101 12.228 13.1265 8.54383 1.14333 3.13472 +459 2 6.09938 13.6243 13.3122 2.17121 -15.6415 -7.8487 +460 1 12.1177 4.51675 13.1173 40.066 24.623 8.84127 +461 2 12.3608 4.67527 14.0558 -10.9347 -6.25445 -11.8552 +462 2 11.2865 4.0907 13.0625 -30.7168 -15.659 3.72413 +463 1 11.4382 8.09379 7.90765 11.4031 -1.65515 0.349674 +464 2 12.1555 7.64923 7.40412 -12.1024 3.57709 12.4555 +465 2 11.7306 8.14579 8.84607 -3.22191 -0.660368 -24.1915 +466 1 17.0422 10.838 7.59458 18.8696 -14.9771 -17.3127 +467 2 17.8015 10.2845 7.30277 -16.9558 5.34042 10.7777 +468 2 16.8989 11.446 6.8574 -4.66599 0.747798 1.74373 +469 1 5.2881 18.0926 10.8094 -12.0199 -6.67836 -5.57022 +470 2 4.87565 17.5902 11.533 4.52174 5.42574 -9.9319 +471 2 4.66447 18.0398 10.0548 7.40461 3.40643 11.786 +472 1 7.61349 17.4864 1.6652 -5.64906 3.24499 15.5952 +473 2 7.84327 16.7088 1.17852 12.3306 -20.6776 -4.28559 +474 2 7.74119 18.1865 1.04014 -3.89506 18.5858 -12.7246 +475 1 1.91944 12.8991 13.6003 2.94725 10.7513 13.4495 +476 2 1.49936 12.2949 14.2301 -1.35275 4.24281 -4.32331 +477 2 2.12078 13.7179 14.107 -1.08361 -15.4355 -11.6139 +478 1 9.36899 6.74386 14.7638 -2.26814 18.4847 -3.39127 +479 2 9.81478 6.02606 15.213 8.95117 -11.473 0.808352 +480 2 9.85086 6.98618 13.9577 -2.76657 -9.1339 3.81591 +481 1 15.2853 4.27459 10.7783 -6.29839 -2.79317 -1.65183 +482 2 16.2088 4.11106 10.5808 3.62417 -3.44414 3.50356 +483 2 15.3067 4.91761 11.4912 -1.69264 4.92972 1.1484 +484 1 11.3393 6.23844 0.0959214 -19.2017 -19.0623 -2.27733 +485 2 11.4465 5.27934 18.8311 9.36926 7.99257 -4.22996 +486 2 10.3892 6.29463 18.5179 14.2332 9.643 5.73673 +487 1 18.5128 11.4549 14.9487 -3.47415 -8.47336 -12.1105 +488 2 18.0135 11.8846 14.234 9.23154 -3.06455 1.62932 +489 2 18.3213 12.0172 15.6945 1.79799 8.69016 10.3557 +490 1 7.01602 9.27569 7.3226 -14.4634 -16.8581 15.1781 +491 2 6.67273 8.48369 7.80259 5.98597 16.4947 -15.5019 +492 2 7.96023 9.16216 7.29002 13.6661 -3.40194 -2.89589 +493 1 18.3593 15.3216 12.2421 14.2565 8.37053 -9.09139 +494 2 0.609114 15.6531 12.0121 -9.26774 -5.34503 6.02371 +495 2 17.7657 15.7501 11.6106 -0.96984 1.15192 3.02291 +496 1 16.5123 4.36636 5.2899 -20.1169 0.0802899 32.1896 +497 2 16.6197 4.39367 6.27015 0.689823 -6.50354 -17.1519 +498 2 17.3637 4.55338 4.93619 30.7718 -0.208347 -14.1282 +499 1 17.7452 3.18489 10.789 3.81546 21.3325 5.47337 +500 2 18.6747 3.34524 11.0396 -11.7638 -6.52287 -4.76545 +501 2 17.6832 2.38146 10.2881 5.2294 -17.628 -7.02183 +502 1 12.3161 18.6216 10.0891 7.2643 12.1904 3.38538 +503 2 11.4836 0.405415 10.3905 15.4316 -4.87983 -6.88019 +504 2 13.0526 0.636416 10.1289 -21.6037 -8.70048 2.57237 +505 1 10.3866 9.75789 12.4872 13.2725 15.9888 14.5072 +506 2 11.1625 9.86545 13.086 -15.7493 -4.39745 -10.7974 +507 2 10.2528 8.81785 12.4 2.63286 -10.7197 -2.15993 +508 1 0.710964 2.68685 7.1375 -0.1398 22.218 7.12103 +509 2 0.988905 3.47272 7.66294 -4.49485 -18.6961 -10.7978 +510 2 0.93208 1.94131 7.68754 4.63119 -8.38422 8.20051 +511 1 0.281684 15.3172 6.85959 12.828 -38.7344 -20.2135 +512 2 0.500898 15.7193 7.67574 7.5107 6.97721 30.9172 +513 2 0.662709 14.3998 6.92418 -16.2289 29.7866 -9.89698 +514 1 17.0547 6.94606 15.0133 0.165691 -3.90506 -0.393601 +515 2 17.812 7.5465 14.9118 -2.55694 -6.08978 1.76467 +516 2 17.3809 6.10212 15.3719 1.63232 8.8395 -1.4121 +517 1 9.12112 12.493 8.02809 -41.9273 18.4298 17.1595 +518 2 9.51251 11.917 7.38329 0.012751 -17.4797 -14.5944 +519 2 8.13115 12.5622 7.88239 38.3085 -7.50107 -2.24579 +520 1 1.15265 1.71178 2.84381 -8.4531 -11.9611 -9.59212 +521 2 1.05399 2.26522 2.05124 -0.803687 -1.8039 9.5303 +522 2 1.83355 2.04817 3.41993 6.13064 16.5152 3.77918 +523 1 4.1533 15.0772 10.0179 -3.20174 -0.437736 -9.29092 +524 2 3.98656 15.1016 9.06421 1.0299 1.2944 4.52592 +525 2 5.05261 14.7702 10.1253 7.00528 -3.42074 -2.93025 +526 1 7.40026 2.22746 14.7687 6.49168 5.19513 -3.0061 +527 2 7.05161 1.63346 14.1063 -3.12724 -4.90201 -3.09738 +528 2 7.91685 2.87588 14.258 -12.5256 -3.95349 11.2802 +529 1 18.373 14.546 2.1576 32.8202 -8.56769 3.71586 +530 2 0.641523 14.7991 2.40659 -13.3331 -4.12423 -2.43111 +531 2 17.8688 15.3457 2.17573 -14.9783 16.0191 -2.18472 +532 1 10.0269 2.72027 12.9069 6.62939 -13.0178 -15.3878 +533 2 10.0552 2.15154 12.1041 -3.85604 9.52515 15.5624 +534 2 9.22213 3.24102 12.837 -1.7712 4.41938 -1.42751 +535 1 2.97754 8.87028 12.9985 -9.05038 -0.677068 -3.47801 +536 2 3.45417 9.69118 12.8049 -4.31376 -0.734034 1.18179 +537 2 3.62806 8.2766 13.3769 7.01874 -2.97808 -1.19575 +538 1 3.19567 8.6035 3.77658 -19.8399 -15.185 62.8422 +539 2 3.69787 9.2024 3.27039 20.7823 26.7884 -21.1607 +540 2 3.25417 8.93577 4.73429 1.71088 -18.6185 -45.3432 +541 1 5.68333 7.2353 8.59567 4.24349 7.94903 8.11652 +542 2 5.64033 6.27333 8.54735 -2.49289 0.630165 -0.0839225 +543 2 5.00997 7.53803 9.22801 3.10928 -6.89318 -6.51723 +544 1 14.901 1.57394 1.8387 15.5968 1.99798 -17.643 +545 2 15.036 2.2757 2.46438 -7.07983 8.8607 13.8203 +546 2 15.4483 1.85956 1.08282 -11.9705 -11.4344 6.74504 +547 1 8.60581 15.0641 0.724175 -1.0343 -0.581701 -1.65436 +548 2 9.36267 14.9264 1.3224 -11.0408 7.07619 -5.07103 +549 2 7.85377 14.5885 1.11097 4.42293 -0.805501 -0.698164 +550 1 15.4669 1.42093 7.20398 -6.02567 -16.758 -12.9624 +551 2 14.8047 0.91537 6.67859 11.4397 13.2212 12.6179 +552 2 15.1632 2.33261 7.23494 -7.42764 0.585266 4.6538 +553 1 4.96609 12.9239 18.4605 4.9692 1.49742 18.5571 +554 2 5.35493 12.9668 0.719228 -7.36506 -0.705061 -15.6984 +555 2 5.64055 13.3191 17.899 -0.422768 -0.432726 -0.922633 +556 1 15.3869 8.64959 18.0541 15.2167 5.00615 -15.1922 +557 2 15.9585 9.21901 17.4831 -18.3202 -12.4364 12.18 +558 2 15.1184 9.19177 0.153179 1.36579 6.92031 5.44875 +559 1 12.0051 3.11685 18.332 2.92261 2.37371 -0.430118 +560 2 12.2267 2.91556 0.611981 0.907964 -7.8545 -12.3252 +561 2 12.4512 2.48545 17.7302 -5.34745 5.71129 14.8863 +562 1 13.1901 12.7142 5.17454 1.37013 -5.58194 -4.10925 +563 2 13.4698 11.8626 4.7966 3.05379 7.74077 7.48289 +564 2 13.3871 12.6804 6.11832 -0.290674 -0.040691 0.190289 +565 1 6.14326 7.19304 0.194857 -1.9202 -41.4233 1.79985 +566 2 6.22321 8.10871 19.0299 -3.97355 27.3971 1.06104 +567 2 5.34431 6.86352 0.645447 4.46952 5.26437 -3.48858 +568 1 17.7307 15.8888 14.9367 -21.823 -0.594011 -1.7362 +569 2 16.7484 15.9241 14.9389 21.2696 3.13718 0.352088 +570 2 17.9521 15.7271 14.013 1.78287 0.501162 -2.11552 +571 1 13.1218 0.925759 16.6825 5.50042 -3.78674 2.95198 +572 2 14.072 0.793445 16.8378 -4.97223 1.91263 -2.37602 +573 2 12.7827 0.0340456 16.5234 -2.01103 3.41826 1.69274 +574 1 10.8951 14.5133 7.41586 13.7556 -0.655539 -10.0126 +575 2 10.113 14.0867 7.762 -7.55253 -2.39401 4.078 +576 2 11.587 13.8348 7.46973 -1.14 7.89944 2.21203 +577 1 17.6887 8.43188 2.14728 0.189858 20.0466 16.1607 +578 2 16.8137 8.45099 2.54699 -1.17102 1.13639 1.13697 +579 2 17.5844 7.88298 1.39033 0.906265 -19.3865 -19.2668 +580 1 12.4753 7.78007 2.02858 4.8513 20.3782 0.840615 +581 2 12.1866 8.68618 1.79587 0.511972 -15.0552 5.00442 +582 2 12.026 7.17575 1.43189 -2.95773 1.13832 -8.42618 +583 1 12.0482 14.5597 10.5042 0.0757192 -7.5571 -35.1431 +584 2 12.4064 14.4181 9.58152 -17.4466 3.18024 31.1693 +585 2 11.0871 14.7065 10.4137 10.382 -0.64313 -2.04102 +586 1 6.77399 6.81718 15.4895 -2.25325 13.5751 22.5023 +587 2 7.66157 7.15195 15.2455 -13.2429 -8.30723 6.82645 +588 2 6.46823 7.3192 16.2828 11.602 -10.345 -19.2772 +589 1 7.96932 4.46689 13.3146 44.2968 21.2749 25.8476 +590 2 7.30275 4.56825 12.6635 -24.5307 9.83264 -18.6775 +591 2 8.36434 5.36687 13.4905 -14.8867 -29.3495 -5.61281 +592 1 13.3256 12.2141 14.3822 1.63527 0.767161 7.05401 +593 2 13.3071 11.2456 14.3976 -5.0343 3.13323 -4.4607 +594 2 13.6638 12.4664 13.5147 0.299935 -1.6824 -0.371902 +595 1 14.5332 9.57639 7.29372 1.70864 -17.4355 -8.36329 +596 2 15.3543 10.0193 7.49698 9.6305 7.8311 1.84335 +597 2 13.8455 10.0241 7.76467 -11.6358 9.67674 12.3645 +598 1 12.6873 16.8129 3.32056 7.83014 22.6359 -6.17069 +599 2 12.905 17.3242 4.12577 -3.6908 -4.91509 -14.526 +600 2 12.6713 17.4548 2.56832 -2.22777 -11.4506 21.1383 +601 1 1.00404 7.03926 17.3541 -3.3312 4.1638 -9.33324 +602 2 0.198847 6.6977 17.7452 -7.86562 1.94891 9.68399 +603 2 0.682364 7.69734 16.7196 12.0745 -4.24482 -2.37704 +604 1 12.9524 4.87174 15.7195 8.90342 0.650689 -3.85785 +605 2 13.7851 4.36673 15.5939 -16.3603 12.0475 7.07164 +606 2 13.1756 5.81397 15.8059 7.81047 -7.07308 -0.568692 +607 1 2.31363 3.41121 5.09984 1.34414 -8.27729 12.6429 +608 2 1.77118 2.94066 5.78541 14.4044 18.7697 -14.1923 +609 2 2.78995 4.15649 5.52715 -11.381 -10.4766 -6.15296 +610 1 8.18617 10.9369 13.7076 0.678078 1.53711 40.2692 +611 2 8.26353 10.8511 14.7174 0.0908521 -0.97824 -49.4206 +612 2 8.97116 10.5326 13.3071 -0.268246 2.83437 5.42064 +613 1 12.9797 1.57395 13.2253 -11.1668 13.2146 -3.30054 +614 2 13.4836 1.606 12.3812 -13.0456 2.80048 17.4401 +615 2 12.3844 2.37352 13.292 24.5144 -24.3843 -9.90982 +616 1 6.623 13.6575 2.08401 -19.1133 11.282 9.3836 +617 2 5.9939 13.9784 2.7781 14.9337 -6.87798 -17.2483 +618 2 7.26745 13.1178 2.55198 -2.04458 -0.845032 2.89429 +619 1 15.8406 6.42424 12.5401 -13.2713 -11.8586 11.2716 +620 2 16.4194 6.98592 12.0445 9.49352 10.2235 -13.5209 +621 2 16.1454 6.51524 13.4484 4.14662 -0.822673 1.52229 +622 1 16.7707 0.701968 9.54479 -0.33564 -15.5889 9.3319 +623 2 16.6398 18.4357 9.88026 3.64558 8.61996 -2.27841 +624 2 16.2643 0.755347 8.72872 -0.899564 4.78829 -7.90839 +625 1 6.16924 11.6733 8.25771 14.6298 -10.0406 -3.26225 +626 2 5.33846 11.3866 8.66461 9.26092 -3.17897 1.03444 +627 2 6.69681 10.8652 8.03849 -20.9756 15.4878 5.14008 +628 1 2.79271 8.6573 0.35403 -23.76 -9.02274 -22.2632 +629 2 2.25448 8.23641 18.2541 16.977 17.0562 34.1458 +630 2 2.21462 9.29512 0.821612 5.57875 -9.71134 -10.0126 +631 1 10.106 10.3292 6.60358 -3.61165 1.9136 -10.2284 +632 2 10.6792 9.71276 7.06962 0.244318 -4.43661 2.14915 +633 2 10.3272 10.2595 5.65755 0.987804 2.37269 11.054 +634 1 6.86896 15.7547 6.74185 -9.45188 0.350857 10.5778 +635 2 7.01957 16.2495 7.56813 1.20841 -3.75655 -8.95365 +636 2 6.86937 16.4078 6.03145 5.97827 -1.66506 -1.56051 +637 1 6.52554 12.9289 5.84178 -0.357514 -5.09084 -2.41361 +638 2 6.62829 13.798 6.2286 3.16894 9.75908 1.28602 +639 2 6.09212 12.3914 6.51525 3.69897 1.96572 0.733322 +640 1 16.7568 12.518 9.72465 -9.23185 -13.2632 0.47822 +641 2 16.902 11.7866 9.09243 0.130969 14.0381 8.74694 +642 2 17.3592 13.2171 9.48659 4.61146 3.47499 -3.98224 +643 1 6.24919 2.86496 2.77119 -11.0856 -12.869 -3.38869 +644 2 6.47325 3.75226 2.51474 6.07925 14.4727 -0.649249 +645 2 5.68088 2.55654 2.04869 4.52067 -4.17334 4.94091 +646 1 10.7277 3.04594 3.24275 -5.68944 3.06595 0.875255 +647 2 10.1765 3.79746 3.50451 2.82785 -3.23936 -2.03517 +648 2 10.278 2.63972 2.48897 0.815959 0.513447 0.723514 +ITEM: TIMESTEP +90 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.787 6.66827 17.9842 -16.1402 -3.16192 1.04025 +2 2 7.92621 6.66814 18.4555 15.1954 -0.455805 -12.5376 +3 2 8.71175 6.0436 17.2441 2.25338 3.19171 10.1252 +4 1 0.22099 8.38854 6.75163 1.7867 -5.58088 53.0968 +5 2 0.258391 8.22026 5.83332 5.30707 -13.3892 -38.1472 +6 2 0.61579 7.61263 7.23543 -10.6686 22.8516 -15.6901 +7 1 8.66795 0.370206 6.9239 18.6241 3.37743 -9.56875 +8 2 9.59619 0.315354 6.61478 -16.3273 1.21351 7.23111 +9 2 8.27983 1.03351 6.33448 -2.90229 -5.54848 4.92815 +10 1 6.43573 1.74596 11.7835 34.1799 -16.6044 -13.764 +11 2 5.93979 2.40996 12.1988 -27.1883 29.6469 18.8725 +12 2 5.80753 1.07598 11.5419 -8.40397 -16.9848 -5.34211 +13 1 6.95318 5.50156 2.37044 -56.4905 40.6357 15.9903 +14 2 6.31995 5.85318 3.09808 38.0444 -22.8427 -29.8317 +15 2 6.63738 6.03683 1.59693 20.7004 -19.4106 17.4304 +16 1 16.2563 10.1963 16.0713 -10.5934 -3.27458 3.94447 +17 2 16.9716 10.3961 15.4827 15.3322 4.9096 -4.70747 +18 2 15.8903 11.0434 16.3496 -2.84586 0.096923 -3.72852 +19 1 10.8156 14.9572 2.29652 -13.5477 -14.1276 -10.2117 +20 2 10.6343 14.4303 3.07787 2.79926 -3.05354 4.26547 +21 2 11.1766 15.7627 2.6355 11.3372 16.7492 6.7502 +22 1 17.2002 8.21443 10.9436 15.2126 5.40823 -8.20499 +23 2 16.6458 8.84622 11.4125 -4.33506 2.62691 -0.328418 +24 2 17.9515 8.74734 10.6145 -8.68143 -7.05886 2.54317 +25 1 14.6067 16.0259 16.3377 27.3765 -5.03456 2.51249 +26 2 13.6996 16.2768 16.4047 -22.3019 9.86517 -5.17321 +27 2 14.7963 15.6285 17.196 -1.96556 -8.36093 -2.03831 +28 1 12.1458 13.2907 0.563101 15.519 -14.4585 7.5186 +29 2 11.8598 13.3671 18.2945 -8.9445 7.51312 -6.12139 +30 2 11.6592 13.8773 1.15113 -3.3891 6.78651 -5.827 +31 1 9.32161 5.49231 3.86239 -40.7454 -0.097831 27.7 +32 2 8.82419 5.45502 4.73277 24.2157 -2.28744 -25.4595 +33 2 8.56838 5.45751 3.23664 18.1191 1.43276 -0.568008 +34 1 1.5546 3.92475 11.5547 -2.15894 45.2634 -4.40984 +35 2 1.55046 4.88574 11.8201 -3.55694 -26.3933 -6.97822 +36 2 1.92957 3.45678 12.2837 10.4321 -13.9157 16.7147 +37 1 2.10319 6.96614 8.15085 -9.44208 -8.37285 -17.308 +38 2 2.4095 7.43328 8.92365 8.57391 0.445975 10.2393 +39 2 2.10294 6.01871 8.3456 1.70875 2.69997 7.84786 +40 1 5.23855 4.482 7.82422 -14.5525 -1.69806 -15.7353 +41 2 5.37847 3.52895 7.72628 3.24739 1.15002 6.52498 +42 2 4.55634 4.7134 7.1559 12.5144 1.33119 10.811 +43 1 3.38552 2.88255 17.3879 -7.38377 33.0145 14.859 +44 2 4.08387 3.35622 16.9066 -6.09174 -4.5148 -0.339366 +45 2 2.81217 3.57956 17.8286 22.0641 -22.8641 -14.398 +46 1 7.5324 5.43864 6.19559 -6.90202 6.90038 35.1799 +47 2 8.08818 5.95892 6.84983 -22.5477 -17.4794 -25.4925 +48 2 6.78022 5.04202 6.71812 26.5249 9.35209 -13.645 +49 1 9.82024 7.03039 12.0775 19.8901 0.0780072 21.9724 +50 2 10.117 6.21395 11.6931 4.07542 -9.22938 -4.80372 +51 2 9.09589 7.30435 11.5485 -23.243 9.22364 -20.0663 +52 1 13.9806 3.7694 8.09667 -19.6388 4.31534 -31.7671 +53 2 13.3819 4.49155 7.81719 15.167 -9.87345 1.12215 +54 2 14.3046 4.00637 8.94223 9.52837 8.93591 30.7953 +55 1 4.52742 17.134 3.88467 -0.450754 13.2049 4.39156 +56 2 5.37483 17.5703 4.13521 -18.32 -2.84079 -10.9512 +57 2 3.94957 17.708 3.32475 23.4139 -10.9615 8.41036 +58 1 16.2726 16.5634 10.552 38.1711 -6.17539 -26.5181 +59 2 15.4837 16.6086 11.0514 -31.396 0.528555 16.213 +60 2 16.0986 15.9648 9.80419 -5.24542 6.81385 7.69127 +61 1 1.94125 4.78402 0.0638345 24.0582 25.3647 11.1071 +62 2 2.62474 5.1599 0.67023 -17.1428 -14.5257 -4.57865 +63 2 1.76164 5.54704 18.141 -7.28608 -7.40463 -3.41134 +64 1 11.2518 13.2771 16.4354 2.60185 -12.9515 -12.3757 +65 2 10.6918 12.4717 16.5304 19.7397 14.6013 -5.52798 +66 2 11.8919 13.1107 15.7025 -16.8897 -0.368153 14.685 +67 1 10.0575 10.919 16.7613 6.16873 -18.0385 3.66167 +68 2 10.4442 10.0133 16.8612 -13.1447 30.924 -0.515142 +69 2 9.09987 10.8482 16.7186 0.711039 -4.16381 0.34444 +70 1 11.8614 17.5086 13.5019 6.48767 -7.71286 -13.5562 +71 2 12.4999 17.0938 12.8959 -9.94411 -4.10313 8.27478 +72 2 12.0757 18.4326 13.4127 -0.0140719 16.2542 2.74368 +73 1 6.39981 9.50139 12.337 -4.6648 -8.8035 -19.3883 +74 2 6.97362 9.2422 11.6012 -0.80266 1.15987 5.77958 +75 2 6.9622 9.95325 12.9581 6.38846 6.66359 6.95977 +76 1 16.2975 12.8974 2.78222 -12.345 -27.8929 4.9875 +77 2 17.1496 13.2141 2.51749 15.349 9.48057 -2.38836 +78 2 15.7502 13.672 2.87844 -10.3717 9.81447 0.854078 +79 1 0.774 12.7819 5.86324 -32.223 -2.64552 -12.7856 +80 2 1.10971 12.9185 4.95432 -4.25214 -7.81578 11.8108 +81 2 18.4306 12.6074 5.76822 36.341 8.50215 1.05579 +82 1 5.29891 16.3721 18.4261 6.47 -16.9938 9.7884 +83 2 5.51669 15.4746 18.1046 -4.53971 18.6444 -2.10572 +84 2 5.85038 16.4657 0.570301 -5.83847 6.29943 -2.02707 +85 1 0.695227 7.70772 4.16735 36.5725 18.4792 -22.7587 +86 2 0.10368 7.96447 3.43723 6.76909 -3.37176 10.733 +87 2 1.60166 8.10351 3.91123 -45.3891 -20.8895 14.9183 +88 1 3.19365 9.10151 6.50287 -37.0597 -13.4257 3.63648 +89 2 3.6513 8.68447 7.23829 0.216969 0.250287 -1.31356 +90 2 2.24726 8.75126 6.54108 37.1121 17.8096 0.286984 +91 1 7.35199 10.4473 16.1779 -19.0362 -10.3824 27.97 +92 2 6.56517 10.9544 15.9216 9.49501 -5.7134 5.26362 +93 2 7.13832 10.0279 17.0488 0.309364 15.3336 -19.7914 +94 1 11.0163 0.890853 5.00632 -3.98909 -12.3472 3.8442 +95 2 10.8807 1.76939 4.61668 6.53092 -8.55309 -4.92776 +96 2 10.738 0.225438 4.34173 2.35985 18.608 2.04389 +97 1 4.21667 2.95093 13.149 10.2014 -19.1015 31.4776 +98 2 4.53515 3.41914 13.9504 -8.71013 -4.86526 -13.316 +99 2 4.15898 1.99936 13.4513 -0.534052 25.4454 -15.6313 +100 1 8.50322 10.2612 1.79208 -4.34668 -17.3092 21.2914 +101 2 8.27549 10.8526 2.5321 5.30441 -1.44182 -6.44774 +102 2 8.58493 9.36982 2.21324 2.85947 21.4101 -9.02924 +103 1 10.3161 1.69184 15.4745 -6.1912 0.342966 -7.58309 +104 2 11.1781 1.38278 15.7166 17.9205 -0.758309 5.87707 +105 2 10.347 1.84648 14.5196 -5.50104 2.18071 3.0962 +106 1 2.60936 12.9662 7.92592 -2.1007 2.96569 -8.82009 +107 2 3.10883 13.7131 7.55922 1.74385 -4.33572 0.675454 +108 2 1.96491 12.7329 7.23617 6.25685 -1.04193 4.90183 +109 1 3.83706 11.6816 4.96058 -22.5573 -14.4893 8.95363 +110 2 3.56827 11.1846 5.76493 10.0033 8.11351 -16.9036 +111 2 3.08816 11.5736 4.33469 10.7007 11.5305 11.906 +112 1 6.6582 14.5337 16.9912 3.19916 -10.5164 -7.18554 +113 2 7.36558 15.1576 17.1605 2.12516 -0.469731 1.77687 +114 2 6.47854 14.5937 16.0445 -2.82585 4.49818 1.60201 +115 1 14.2037 14.4903 3.21857 16.956 -7.57282 -16.8086 +116 2 13.9492 15.374 3.44691 -9.21692 15.261 -0.929302 +117 2 13.8764 13.9351 3.91269 -8.69982 -10.6193 13.7942 +118 1 8.69855 18.0357 16.1264 41.5507 -6.08144 10.5978 +119 2 9.33855 17.4056 16.5195 -30.3672 -5.67283 -6.86348 +120 2 9.34419 0.0405339 15.8183 -19.2067 16.0047 -5.03817 +121 1 4.69307 1.79842 4.89677 16.2385 30.5389 -26.6001 +122 2 3.80396 2.19318 4.80489 14.8244 -2.46841 6.40587 +123 2 5.29999 2.32882 4.27745 -28.5893 -25.5208 24.7929 +124 1 15.0277 12.5795 16.5521 32.6678 1.07726 26.51 +125 2 14.723 12.7481 17.4682 -6.07814 3.10734 -21.8061 +126 2 14.3421 12.5499 15.8992 -22.7964 0.862239 -7.92322 +127 1 15.7044 18.5089 16.8468 26.9219 -3.0014 45.6431 +128 2 16.268 18.6119 17.6883 -20.0241 -2.05323 -42.0683 +129 2 15.5234 17.5608 16.7959 -6.5303 3.1055 -1.70461 +130 1 1.37672 1.34924 16.652 -10.0314 2.12664 3.94932 +131 2 2.13238 1.94076 16.8287 -14.5592 -12.7899 -0.0819953 +132 2 0.657997 1.59844 17.2733 17.8805 -0.89879 -9.33461 +133 1 18.2331 4.34642 15.9005 -0.884234 -3.04582 -21.1642 +134 2 17.8346 3.73179 15.2509 9.01129 10.3034 11.7071 +135 2 0.449037 4.61451 15.5361 -9.49368 -5.77709 6.1071 +136 1 12.1007 17.0847 16.1341 -21.8736 -13.8645 50.4236 +137 2 11.3773 16.6353 16.6829 29.7152 15.2039 -30.2146 +138 2 11.8045 17.1565 15.2358 -4.92233 -3.24187 -16.5992 +139 1 16.1203 2.66556 18.245 -33.6191 11.8512 -24.8852 +140 2 15.5683 3.39571 18.6154 19.5646 -10.4389 -9.45588 +141 2 15.8602 2.60471 17.2935 4.4965 0.524143 22.3318 +142 1 6.68711 13.7575 10.0686 6.57394 0.780895 15.4701 +143 2 6.65896 13.3749 10.963 -3.37269 2.77311 -6.77332 +144 2 6.71723 13.0193 9.46247 -3.0919 -8.05072 -6.49535 +145 1 10.1832 18.4638 2.68288 15.4984 11.1175 -14.1442 +146 2 10.4797 0.410785 1.94548 -7.56539 -13.8801 19.3089 +147 2 9.29042 18.2071 2.48382 -12.5464 -2.66261 -5.58966 +148 1 3.06565 17.654 6.19973 -11.4817 2.82915 -15.5316 +149 2 2.17867 17.6912 5.79869 7.15707 -3.68965 15.0105 +150 2 3.60434 17.7569 5.40979 11.429 -4.57556 5.13078 +151 1 12.6359 16.7831 7.87678 -34.4323 5.42099 5.88286 +152 2 11.8215 16.2589 7.70694 19.4452 0.972157 -0.554869 +153 2 12.3283 17.4377 8.53506 12.9634 -4.48143 -6.06952 +154 1 14.8812 15.2555 8.26349 -9.13488 6.23831 13.721 +155 2 14.2179 15.9485 8.09528 6.25869 -7.42326 0.874894 +156 2 15.4123 15.1764 7.46942 0.572987 8.13089 -2.89012 +157 1 17.8363 18.2748 0.235726 -36.9104 2.14965 -2.72595 +158 2 18.5544 17.6878 0.132306 25.4932 -25.6882 -8.95291 +159 2 18.2375 0.371142 0.648791 5.78715 27.9621 12.2792 +160 1 0.76648 10.5228 1.42349 -23.6052 -44.6853 36.9297 +161 2 -0.0625164 10.0248 1.72181 36.7073 15.4552 -13.6362 +162 2 0.483164 11.1861 0.82966 -10.4498 25.872 -24.2739 +163 1 1.81496 12.3027 3.28068 4.06427 7.40541 18.1542 +164 2 1.38036 11.6556 2.74613 -8.62838 -16.0879 -14.4133 +165 2 2.12935 12.9782 2.6808 0.203437 6.54347 -1.70293 +166 1 0.715096 17.2857 4.99328 6.02973 16.9927 -22.851 +167 2 -0.0549074 17.8034 5.17132 -8.63108 24.1627 -3.07112 +168 2 0.561936 16.5317 5.51148 1.70853 -39.3498 23.4345 +169 1 1.0126 0.815092 9.34853 9.77893 1.05612 10.9097 +170 2 1.24172 0.537916 10.2451 4.93082 3.28815 4.21298 +171 2 0.133534 0.483606 9.24599 -18.3012 -2.93221 -7.23643 +172 1 16.7899 2.36695 13.4143 1.34336 11.0529 -24.546 +173 2 16.9036 2.71504 12.491 -0.235106 -7.90147 26.8103 +174 2 16.4417 1.47344 13.309 3.25474 -1.82726 5.59598 +175 1 2.66167 16.0077 12.0598 12.6303 -22.6944 6.71055 +176 2 3.01062 15.6298 12.8947 -8.01809 9.38789 -15.4913 +177 2 3.11281 15.5097 11.3415 -7.7677 12.8204 10.8964 +178 1 16.364 15.512 6.14932 19.0855 9.58845 -19.9598 +179 2 17.3177 15.4404 6.40388 -23.0707 9.20906 -7.80583 +180 2 16.2465 16.2844 5.52559 8.28806 -24.9431 19.8586 +181 1 5.77951 5.20043 11.8033 8.47507 -20.9263 -15.707 +182 2 5.6405 6.00993 12.2754 -6.27864 14.793 10.9641 +183 2 5.18835 4.5564 12.2066 -2.11002 -1.11499 -2.91817 +184 1 15.1794 4.92089 0.775894 -18.0102 -8.76269 31.4284 +185 2 14.9497 4.67568 1.72392 8.26683 8.97624 -32.6089 +186 2 14.3636 5.23769 0.366515 4.70525 -0.664057 3.69432 +187 1 16.3975 16.4382 1.83859 15.8969 -1.83249 -31.9545 +188 2 16.3175 16.7184 2.73629 -8.02889 11.6848 21.5541 +189 2 16.8259 17.1655 1.34034 -8.03244 -7.80667 10.4102 +190 1 0.153841 4.83744 3.963 18.3567 41.8245 -8.83163 +191 2 0.481764 5.78512 3.86014 -17.0028 -34.1388 7.97498 +192 2 0.952119 4.32423 4.11352 -0.77715 -2.59924 4.82879 +193 1 2.94647 15.0748 15.1079 -17.5423 -9.74792 39.2804 +194 2 2.84668 14.6538 16.0052 7.88621 4.55617 -28.9019 +195 2 2.37581 15.8415 15.2342 5.36547 9.02165 -11.4736 +196 1 1.04118 14.6398 9.41517 21.0794 -20.4815 -17.0137 +197 2 1.63478 13.9208 9.06194 -19.3512 25.5288 8.96267 +198 2 0.7851 14.3144 10.2695 -7.28135 -4.68142 11.1743 +199 1 13.5343 16.512 11.5541 0.415781 17.9887 -13.1724 +200 2 13.2087 17.3014 11.0493 5.42519 -19.6136 10.4452 +201 2 13.1525 15.7431 11.1062 -5.37134 4.1326 5.42785 +202 1 4.79073 1.57335 0.678685 -10.2425 -16.6589 -0.602312 +203 2 4.2243 2.02466 0.0269211 5.06007 -3.50169 9.95598 +204 2 4.26355 0.829094 1.04695 5.40097 16.8315 -2.73739 +205 1 1.55169 18.6011 11.9401 -14.2618 14.3088 -13.4455 +206 2 1.54559 0.423493 12.7773 -0.760074 5.21042 2.72529 +207 2 2.10509 17.8447 12.0596 11.7149 -17.0814 4.30068 +208 1 11.3926 10.0859 4.15406 35.1149 20.4659 -18.5884 +209 2 11.4922 10.6036 3.30306 -8.07316 -21.3073 26.3838 +210 2 12.3257 9.94393 4.45754 -25.8381 1.71308 -8.95455 +211 1 8.18732 12.2257 3.75704 -12.727 -0.351394 27.2441 +212 2 9.08394 12.5468 4.00553 -19.5779 -3.96369 2.83586 +213 2 7.55786 12.2705 4.55735 35.1927 2.13842 -31.3906 +214 1 14.6183 4.0143 3.36201 13.432 11.2186 16.7224 +215 2 15.2472 4.27703 4.07585 -12.4329 -9.47893 -15.9273 +216 2 13.7521 4.30159 3.67007 -0.91716 0.860244 -2.07153 +217 1 5.73358 1.67843 7.60794 -24.3615 -22.8066 38.6551 +218 2 5.03202 1.06037 7.9982 26.7251 29.011 -15.8684 +219 2 5.4689 1.83957 6.71483 -6.40801 -4.86943 -26.9957 +220 1 17.8709 0.966847 4.84319 9.19834 18.9135 -13.8104 +221 2 18.365 1.30942 4.06688 -7.16187 -11.4028 13.2983 +222 2 17.8528 1.72071 5.45189 -4.56365 -9.98849 0.137087 +223 1 6.8232 9.21412 4.53503 0.0591715 -6.07859 -16.7729 +224 2 6.61803 9.33533 5.45725 2.71524 4.28405 13.1117 +225 2 7.76963 9.02928 4.48077 0.0640272 -1.66157 1.55662 +226 1 2.43776 14.707 2.05519 12.3789 -12.7502 -17.0618 +227 2 3.26162 14.6424 2.56361 -5.44595 2.48516 -0.426941 +228 2 2.66563 14.4192 1.14611 -3.66427 9.22898 15.3942 +229 1 17.2291 12.9271 13.0675 -25.7945 34.5425 2.40746 +230 2 16.3582 13.328 13.3279 21.6203 -16.0155 -5.62376 +231 2 17.7378 13.7209 12.8173 -0.837652 -12.191 -0.563337 +232 1 14.8245 10.5613 1.47762 -19.5687 -28.1113 -12.7998 +233 2 15.3117 11.2776 1.82539 19.2978 30.1093 14.6064 +234 2 13.9052 10.723 1.70642 0.475408 2.13461 -1.67485 +235 1 5.64982 6.63563 4.55084 7.38671 -15.2963 15.0755 +236 2 5.89214 7.54949 4.44479 2.16454 16.7651 -4.4857 +237 2 6.3044 6.30345 5.19757 -6.24708 1.07556 -9.93912 +238 1 8.10845 8.3271 10.3627 -2.57156 5.78827 13.3728 +239 2 8.61892 8.85799 9.7482 5.06505 3.86155 0.738683 +240 2 7.30116 8.09886 9.91192 -6.7312 -10.1116 -10.9746 +241 1 13.4488 18.4608 5.65963 -13.3307 -19.6223 8.99938 +242 2 12.6096 0.239632 5.39678 7.81848 3.10411 6.37483 +243 2 13.1935 17.7385 6.2846 5.11891 19.4349 -8.45882 +244 1 -0.00278136 2.5625 0.408955 -12.183 35.1922 -19.112 +245 2 17.7147 2.60224 18.7259 18.9642 -9.11891 12.7486 +246 2 0.290302 3.48872 0.227759 6.22068 -26.2608 7.60118 +247 1 12.9842 10.8497 9.70117 -72.6257 27.1129 -13.2266 +248 2 11.97 10.965 9.69449 48.4921 6.31007 0.109369 +249 2 13.0048 9.91956 9.83068 16.3628 -25.292 6.36111 +250 1 0.548273 12.2593 11.2103 29.2233 3.63314 -8.31727 +251 2 18.2651 12.1894 11.4198 -11.8267 3.42799 7.99272 +252 2 1.06577 12.5175 11.9926 -12.6507 -2.71608 -2.06856 +253 1 5.24515 7.35168 13.3154 -11.9716 -5.94003 -7.6844 +254 2 5.73604 8.07931 12.9223 2.64227 5.43904 4.60776 +255 2 5.63818 7.16239 14.1672 7.7875 0.124539 4.29694 +256 1 1.16856 6.76355 12.0035 -37.5881 -40.6251 -19.8542 +257 2 0.334741 7.08942 11.6206 8.86965 -4.87383 5.4559 +258 2 1.63397 7.52151 12.2381 28.649 45.7996 14.9133 +259 1 15.5501 9.75639 12.3967 -1.92883 21.1886 15.8166 +260 2 15.1116 10.6344 12.221 21.3449 -31.3991 6.12972 +261 2 16.0605 9.85526 13.2245 -13.7753 0.465455 -14.4819 +262 1 16.5858 12.6354 5.59083 -2.62715 14.8355 -19.0185 +263 2 16.4437 13.5882 5.83081 0.436603 -22.1434 -16.2318 +264 2 16.416 12.5171 4.60718 5.48378 12.0784 33.3147 +265 1 6.40279 9.86277 0.0794915 -20.3924 -8.41649 -9.56759 +266 2 5.55524 10.218 0.380594 4.23452 2.32222 -1.66862 +267 2 7.0555 10.2042 0.674211 16.128 4.48978 14.4774 +268 1 12.2427 6.01171 4.00399 -23.1281 -36.6346 24.2315 +269 2 12.2798 6.64894 3.31747 0.117026 23.2517 -16.0656 +270 2 11.2984 5.74139 4.08171 19.6095 7.84283 -4.73597 +271 1 0.360057 12.9056 0.031807 -8.11921 2.1908 5.08387 +272 2 18.8977 13.4796 0.805411 -3.72305 -1.59029 -3.55744 +273 2 18.3786 13.2516 18.0169 7.85083 -4.92073 3.80969 +274 1 3.55677 18.7152 8.66247 19.9063 -6.335 -5.44295 +275 2 3.49677 18.1902 7.8473 -5.97778 6.84736 4.02201 +276 2 2.66917 0.348355 8.87781 -8.06089 0.921211 -3.36616 +277 1 7.26214 17.4262 4.43744 19.2672 26.0801 -3.30237 +278 2 7.75433 18.2474 4.74147 -22.4281 -27.0983 -14.818 +279 2 7.37471 17.3728 3.46226 -1.25032 2.03681 18.5343 +280 1 9.25258 17.1703 12.1759 28.8617 -14.1678 9.07352 +281 2 9.26958 16.3393 11.6513 -2.57153 16.4076 7.11435 +282 2 10.1283 17.1978 12.6604 -29.6357 0.448077 -14.593 +283 1 13.2677 13.193 7.99719 -21.1722 -32.5843 10.0566 +284 2 13.3388 12.6042 8.77917 0.104276 5.764 -17.169 +285 2 13.8077 13.9427 8.17139 23.4211 18.1414 5.93605 +286 1 14.7593 2.91325 15.4943 24.3728 -2.49696 -23.5999 +287 2 14.0361 2.3713 15.1546 2.238 -3.60609 4.01929 +288 2 15.4274 2.94021 14.7667 -15.6113 -2.56038 15.0831 +289 1 9.9738 15.6484 16.9671 -8.54083 0.59912 -5.05632 +290 2 10.1057 14.7848 16.5569 10.1368 1.85589 1.18764 +291 2 9.46144 15.457 17.7506 -1.80616 -1.66933 10.9911 +292 1 11.2344 8.55758 16.6355 7.77426 1.92795 -6.45244 +293 2 10.4646 8.11257 16.295 -8.96701 -9.58703 -5.10609 +294 2 11.6991 7.91388 17.1598 3.61158 -8.68538 8.99751 +295 1 4.14955 18.3179 16.8036 -6.71252 9.00681 -6.36217 +296 2 4.47312 17.6803 17.4466 6.33314 0.74429 2.85153 +297 2 4.24503 0.569095 17.1648 -0.42517 -11.8307 0.148866 +298 1 2.33957 4.29184 8.91302 22.2448 -7.34702 27.8454 +299 2 3.30686 4.08394 8.81247 -29.123 7.66299 4.05924 +300 2 2.12598 4.16624 9.8839 8.54186 0.354435 -34.7065 +301 1 9.95255 10.4179 9.8571 -18.8164 27.0404 -12.2944 +302 2 9.4534 11.1894 9.4744 17.3372 -21.5482 9.10503 +303 2 9.8309 10.4683 10.8129 6.92766 -2.76642 -0.156957 +304 1 9.80127 0.922938 10.8108 4.3272 3.59983 6.04006 +305 2 9.35046 0.175669 11.2139 0.840012 -6.18623 1.13214 +306 2 9.1369 1.38463 10.2905 0.460774 -0.831922 -5.90435 +307 1 9.16459 15.1765 10.2101 -26.8722 -7.06493 -21.2153 +308 2 8.97785 15.8968 9.57551 3.0406 -6.31351 13.2231 +309 2 8.39419 14.5643 10.0571 23.5779 16.7742 11.4525 +310 1 0.773683 9.7544 10.1833 18.261 11.1305 -23.2394 +311 2 0.868202 10.7262 10.3345 -3.82315 -24.612 -0.100636 +312 2 1.30536 9.53677 9.37727 -17.4146 8.84667 24.1623 +313 1 17.2096 4.87642 8.04469 -12.9959 -9.21067 35.1395 +314 2 16.3347 5.16277 8.3943 19.7751 -0.094318 -9.55648 +315 2 17.6197 4.3572 8.78272 -10.3132 11.9302 -24.4143 +316 1 14.8095 14.6496 0.0373288 -5.69372 -9.04424 21.9283 +317 2 15.5101 14.9524 0.640087 -10.906 0.748239 -2.66247 +318 2 14.0769 14.3265 0.613297 14.425 8.36295 -12.6903 +319 1 3.89537 11.0996 9.55593 -9.82967 16.3938 -0.398364 +320 2 3.93242 11.2996 10.5001 -1.21387 -1.78602 1.5381 +321 2 3.39392 11.8407 9.15947 5.2768 -13.1919 0.569667 +322 1 11.4169 10.7371 1.49225 5.47317 24.4145 -6.81884 +323 2 11.5532 11.6314 1.08329 0.074839 -23.6179 10.2373 +324 2 10.4618 10.6109 1.50924 -1.9569 -1.96948 -2.8184 +325 1 13.1395 7.21524 12.5729 -20.455 -7.16835 0.858137 +326 2 14.0577 7.03675 12.4308 23.1896 -1.74136 0.0778831 +327 2 12.7378 6.3322 12.608 -1.47964 6.92135 2.9072 +328 1 9.65614 1.96645 0.86496 18.1931 4.09637 20.8777 +329 2 8.84682 1.67677 0.484793 -23.8326 -3.90796 -8.97572 +330 2 10.1746 2.31935 0.150168 8.91513 5.01659 -9.40528 +331 1 10.6386 13.4197 4.53193 2.28663 -4.65747 18.8344 +332 2 11.4948 12.9639 4.69275 -16.1918 12.7288 -0.469196 +333 2 10.3958 13.8423 5.38242 9.30576 -5.17735 -13.1714 +334 1 14.5273 1.57884 10.9459 15.1221 22.4117 -0.776229 +335 2 15.362 1.31139 10.5257 -10.7732 -5.17355 3.70166 +336 2 14.6474 2.54531 11.0746 -6.11584 -12.5888 -6.32845 +337 1 14.4766 12.0159 11.6273 -10.9263 4.56586 -44.1867 +338 2 15.2047 12.4077 11.0864 -12.0042 -9.95663 15.0185 +339 2 13.8634 11.5981 10.9451 22.3117 17.3775 30.6101 +340 1 8.16847 5.14124 9.81669 -29.5484 17.7318 23.7918 +341 2 7.27475 5.12719 10.2684 30.6512 -1.40914 -16.6308 +342 2 8.33799 4.26267 9.50012 -3.06916 -18.2431 -3.24008 +343 1 1.5108 16.9662 18.5044 9.55151 26.7901 -23.2493 +344 2 1.84435 17.2897 17.6363 -7.76754 -5.77411 19.656 +345 2 1.83481 16.0826 18.5596 5.96378 -22.3257 1.76596 +346 1 1.42717 17.3886 15.3379 47.0554 -13.0927 -7.45492 +347 2 1.50543 18.1882 15.8264 3.14075 27.3625 12.617 +348 2 0.523906 17.2066 15.2924 -49.7083 -12.5335 -2.74225 +349 1 3.49173 5.73723 6.04987 -5.63889 12.5308 6.32322 +350 2 3.05134 6.46754 6.5425 11.5005 -15.9447 -9.63575 +351 2 4.14223 6.14285 5.45548 -4.8412 1.1033 3.2125 +352 1 12.5916 9.51872 14.2408 10.4293 -27.0271 -12.8548 +353 2 13.028 8.79356 13.6831 -19.628 26.0366 30.4849 +354 2 12.3513 9.14884 15.1174 6.55215 0.813797 -17.5332 +355 1 4.09544 15.2089 7.12218 31.8609 13.6269 2.32941 +356 2 3.67616 16.0257 6.80924 -1.84113 -5.17266 1.34804 +357 2 5.07546 15.4284 7.13078 -32.8392 -10.6488 -3.17146 +358 1 0.799143 8.79431 15.1488 8.21516 12.8732 -16.9375 +359 2 0.575284 9.7423 15.0796 -2.5473 -12.0602 5.3867 +360 2 1.52676 8.70151 14.5038 -8.32138 -2.51513 8.31525 +361 1 12.8725 8.28632 10.0993 13.5644 -10.3417 -12.785 +362 2 13.6812 7.81606 9.78663 -13.8637 7.80766 13.5238 +363 2 12.7502 8.10095 11.0322 6.24745 -8.27276 5.3213 +364 1 15.2423 7.98405 3.44353 15.6799 19.5655 -11.9659 +365 2 14.4463 7.83544 2.89643 5.54982 -16.2362 17.4101 +366 2 15.5184 7.39607 4.17406 -22.72 2.15229 -11.0841 +367 1 17.1687 6.76019 0.0376092 -10.314 6.5713 -12.413 +368 2 16.7239 5.93548 0.292072 -0.0664332 9.88195 -1.29815 +369 2 16.4741 7.34647 18.2846 16.8516 -16.4801 16.1304 +370 1 8.96925 6.98328 7.86383 -27.8745 -15.8066 22.0328 +371 2 9.86939 7.24269 7.81058 30.3142 9.1639 -3.03437 +372 2 8.87474 6.48936 8.713 -1.39219 10.6855 -19.1169 +373 1 12.482 0.614891 1.23015 1.92335 -8.70167 1.10105 +374 2 13.2432 1.03802 1.64803 2.06157 -2.24376 -3.30204 +375 2 12.803 0.16068 0.442821 -0.913907 6.47573 3.0001 +376 1 5.66871 15.0647 14.4598 7.14191 19.2454 -5.51099 +377 2 4.75956 15.0903 14.7907 1.11348 4.01334 -3.77227 +378 2 5.94804 16.0038 14.294 -6.0872 -24.4911 3.70117 +379 1 3.73529 6.48244 1.70347 -4.32476 7.10488 -19.4811 +380 2 3.3805 7.26573 1.22404 3.0021 -10.505 14.7125 +381 2 3.73285 6.71028 2.6365 -0.71904 4.06656 1.73817 +382 1 3.86925 11.322 12.3296 2.55777 5.65869 0.326193 +383 2 4.7048 11.7602 12.5386 0.0734552 -4.93202 -1.70743 +384 2 3.20028 11.8652 12.7549 -2.96009 3.18005 0.676376 +385 1 5.3196 3.88545 15.7107 -12.565 72.4648 14.1271 +386 2 6.00107 3.31 15.4478 35.5939 -28.3589 -8.92722 +387 2 5.74724 4.80358 15.8116 -17.6513 -43.1362 -7.7855 +388 1 14.0258 10.1309 4.70784 36.378 -19.982 -23.5474 +389 2 14.2654 9.87929 5.60631 -3.02994 -1.07275 0.485782 +390 2 14.6765 9.60938 4.12831 -34.5421 20.7478 23.7761 +391 1 7.50853 17.298 8.98976 4.28677 22.6193 13.4416 +392 2 7.01472 17.6504 9.76182 0.935323 -12.9311 -15.6818 +393 2 7.87431 18.0869 8.55212 -1.49272 -9.54271 -2.09709 +394 1 4.57424 14.4015 3.77738 -1.32578 6.84514 50.6918 +395 2 4.51443 15.3073 4.2079 4.46262 -31.6709 -20.6737 +396 2 4.58351 13.7394 4.53798 -1.39317 23.0513 -31.5206 +397 1 14.2431 7.32994 15.8885 26.8814 9.55229 5.02737 +398 2 15.048 7.31796 15.3145 -19.1816 0.583054 17.9404 +399 2 14.5184 7.8184 16.7026 -8.00009 -12.2304 -19.9762 +400 1 3.00564 18.4171 1.98737 1.19435 35.3283 33.2576 +401 2 2.60973 17.9491 1.28647 -18.7059 -24.7202 -27.1582 +402 2 2.28625 0.311703 2.39571 15.2164 -11.2621 -13.5372 +403 1 7.97098 1.60459 4.54116 29.2267 3.13781 -13.0843 +404 2 7.39603 1.96083 3.86318 -8.15365 2.40339 -0.697123 +405 2 8.86388 1.74438 4.1564 -17.9094 -5.03071 12.9608 +406 1 2.50155 14.1648 17.7228 -14.4362 -20.2086 14.4505 +407 2 1.80023 13.5192 18.0233 22.5798 22.6486 -13.5864 +408 2 3.34474 13.7188 17.8802 2.38023 -0.79805 1.89101 +409 1 0.962462 1.97628 13.8796 24.0866 5.42438 -18.2963 +410 2 1.23331 1.73159 14.7528 2.00372 -3.67266 20.967 +411 2 0.0219615 1.96156 13.879 -26.3344 -0.788872 -2.58417 +412 1 4.34962 0.156713 13.8729 25.4477 -1.51409 -1.97896 +413 2 5.30295 18.5478 13.9084 -21.2168 3.6137 -4.76321 +414 2 3.99528 18.4902 14.7051 -3.29088 -0.042535 8.53213 +415 1 7.35889 1.01117 18.4602 -20.0845 2.29217 31.534 +416 2 7.53777 0.614221 17.6282 1.02155 -13.8743 -28.1328 +417 2 6.39885 0.929085 18.6632 17.4429 7.83311 -8.37388 +418 1 15.8463 18.3909 13.9448 -43.3072 10.6601 -1.92517 +419 2 14.916 18.6906 13.7723 29.0574 -10.6436 -1.66619 +420 2 15.8257 -0.445507 14.8871 10.2412 6.45473 0.424587 +421 1 10.2808 4.63783 16.2194 -42.4572 -26.934 -19.6441 +422 2 11.2059 4.65809 16.3645 33.0638 0.71496 4.62375 +423 2 10.0964 3.70704 15.9214 4.59595 26.5122 11.6188 +424 1 15.903 17.6519 4.47823 -22.6026 32.3058 18.5214 +425 2 16.5145 18.4189 4.46111 -7.58873 -12.9749 2.84853 +426 2 15.0701 18.0221 4.91498 30.26 -18.095 -22.6862 +427 1 6.91987 17.5654 13.9309 41.5981 2.12242 13.325 +428 2 7.49428 17.7119 14.7497 -22.2257 -6.74767 -31.4029 +429 2 7.56851 17.4237 13.1898 -17.2813 4.26485 21.283 +430 1 13.2143 6.40362 6.52296 -17.8609 -7.45559 2.6451 +431 2 14.0836 6.75111 6.37132 17.2928 3.48546 -1.85822 +432 2 12.8363 6.25317 5.64277 2.90235 4.29902 5.97585 +433 1 7.86013 2.26394 9.49062 -8.36252 -9.46169 -35.4407 +434 2 7.29684 2.1706 10.2513 -11.7917 -0.851936 13.7299 +435 2 7.34714 1.87564 8.72892 15.7155 15.0955 20.8405 +436 1 15.1343 14.8378 13.7575 -15.8142 13.0315 4.83039 +437 2 14.8532 15.0481 14.6708 3.35379 -3.45087 -12.098 +438 2 14.5629 15.3828 13.1802 11.493 -9.40285 7.27009 +439 1 9.38118 8.39884 3.83519 4.0123 -7.74443 -2.87465 +440 2 10.2467 8.83344 3.97294 -13.6344 -10.1795 -2.34121 +441 2 9.51993 7.43201 3.84247 0.270426 14.3255 0.324032 +442 1 17.6982 13.5806 16.4882 -11.1823 29.4115 -15.1875 +443 2 16.7477 13.4163 16.452 -1.16521 -4.14372 2.83933 +444 2 17.7994 14.4458 16.0124 3.95943 -25.1425 10.6502 +445 1 4.93057 10.3937 2.82949 21.3493 0.31084 -7.87351 +446 2 5.82872 10.0425 3.0149 -20.5327 4.11374 3.5741 +447 2 4.70497 10.9363 3.59521 3.63155 -1.89772 -0.291932 +448 1 3.65557 8.40975 9.92882 -7.92631 -13.4411 16.4299 +449 2 3.66668 9.34394 9.72247 1.00161 8.70404 1.26029 +450 2 3.36367 8.33438 10.8592 4.36465 5.8519 -13.4993 +451 1 15.9508 6.91708 5.85912 26.4071 -7.62551 -3.83966 +452 2 16.729 7.34279 6.26867 -14.5536 -3.6129 -4.6023 +453 2 16.2929 6.05819 5.53033 -12.7649 13.2481 9.54942 +454 1 15.2478 7.26488 8.9948 -11.5397 21.0457 -23.7706 +455 2 16.0349 7.57374 9.47019 -5.83 4.16597 -2.61919 +456 2 14.9977 7.92652 8.27445 16.2337 -23.38 28.7542 +457 1 6.17715 12.7863 12.74 7.06624 23.8889 14.8517 +458 2 6.98998 12.4152 13.1111 -3.934 -5.41615 -1.6338 +459 2 6.02064 13.6181 13.2483 1.6805 -16.267 -10.1818 +460 1 12.1255 4.53395 13.1266 36.5984 28.8141 18.352 +461 2 12.1988 4.68857 14.088 4.72218 -0.985297 -9.83354 +462 2 11.344 4.04995 13.0228 -42.0246 -23.4808 -8.79261 +463 1 11.4542 8.08345 7.86287 23.2187 -10.867 14.4494 +464 2 12.2022 7.55078 7.50013 -20.6002 10.1652 -0.104446 +465 2 11.6749 8.16233 8.821 -5.77941 1.62242 -23.2927 +466 1 16.9966 10.8 7.60022 14.0465 -17.3895 -10.8701 +467 2 17.6655 10.1188 7.31004 -18.6815 22.6831 6.1404 +468 2 16.8855 11.476 6.90625 3.56282 -12.242 0.823841 +469 1 5.28409 18.0615 10.7272 -25.4136 -4.73004 -4.09376 +470 2 4.85025 17.4105 11.3211 10.0924 14.2936 -14.0097 +471 2 4.61921 18.235 10.0106 18.3134 -6.11244 18.1083 +472 1 7.63344 17.4775 1.60819 -12.3126 -2.35291 35.094 +473 2 8.06049 16.702 1.26786 10.3266 -12.472 -14.3961 +474 2 7.64482 18.174 0.971148 2.96613 14.6858 -21.2308 +475 1 1.92556 12.9088 13.6099 -6.92879 6.84011 17.0322 +476 2 1.40166 12.3078 14.1747 6.51182 9.66465 -5.96466 +477 2 2.01688 13.7519 14.1152 3.80073 -20.221 -11.3532 +478 1 9.32296 6.74742 14.7603 -6.16505 19.9578 -6.21839 +479 2 9.80961 6.04203 15.1542 10.8193 -23.4577 14.2182 +480 2 9.81429 6.97553 13.9666 -4.58884 0.0213979 -5.59057 +481 1 15.2687 4.29028 10.7744 -16.6773 -11.1812 -9.87371 +482 2 16.185 4.03181 10.6852 9.89086 1.55812 4.86514 +483 2 15.2046 4.88146 11.5266 6.28069 5.56792 1.9642 +484 1 11.3833 6.23863 0.0689293 -3.19885 -6.29427 4.65322 +485 2 11.5449 5.27036 18.7473 -10.1654 17.1623 -6.02864 +486 2 10.4171 6.41156 18.6664 16.019 -11.974 -2.10863 +487 1 18.4779 11.4738 14.9298 -4.11302 6.12113 -30.5228 +488 2 18.0937 12.0014 14.1715 8.36132 -18.8326 26.0479 +489 2 18.3027 12.0103 15.7035 0.536699 7.83234 4.13522 +490 1 7.03799 9.27423 7.33397 -11.8444 -18.9096 15.35 +491 2 6.61404 8.50211 7.787 12.2323 17.6714 -16.3801 +492 2 7.97664 9.07639 7.31215 4.33333 -2.45816 -2.54611 +493 1 18.3885 15.3347 12.1965 11.3664 3.9942 -3.56245 +494 2 0.676524 15.5664 11.9851 -14.9026 2.39255 4.26485 +495 2 17.8062 15.8491 11.6143 4.55299 -1.04774 1.98359 +496 1 16.551 4.342 5.30396 -29.3567 -2.30965 40.8017 +497 2 16.5003 4.35995 6.30392 8.99046 -4.55546 -31.3189 +498 2 17.4312 4.58446 5.06774 26.2551 1.0485 -9.7407 +499 1 17.7614 3.18175 10.7726 14.454 -1.68376 5.55906 +500 2 18.6848 3.25815 11.0867 -17.2868 6.635 -4.74284 +501 2 17.731 2.30667 10.3896 -4.78084 -7.5669 -7.23363 +502 1 12.3288 18.6185 10.0887 4.81564 48.0444 9.66027 +503 2 11.5224 0.4701 10.402 18.5752 -22.9317 -12.6203 +504 2 13.04 0.683861 10.1001 -20.831 -28.6711 -0.571217 +505 1 10.4023 9.75891 12.5069 9.56908 10.7357 22.5843 +506 2 11.0968 9.84844 13.1991 -9.82495 1.00858 -15.0243 +507 2 10.3005 8.81694 12.4067 -0.389825 -11.0581 -5.16736 +508 1 0.728244 2.62509 7.20528 10.511 21.9286 8.67284 +509 2 1.10851 3.44304 7.59367 -9.47208 -14.047 -5.98037 +510 2 0.946108 1.9669 7.86838 0.119732 -6.07738 -1.41007 +511 1 0.301432 15.3195 6.88989 15.9737 -48.0831 -14.5816 +512 2 0.502768 15.5752 7.7858 2.08568 -2.79341 12.7124 +513 2 0.620951 14.3521 6.81024 -17.8336 49.2232 -1.9498 +514 1 17.0496 6.91172 14.9593 8.8057 -4.67917 1.70395 +515 2 17.812 7.50707 14.8676 -6.01141 -3.19386 0.836122 +516 2 17.3983 6.09137 15.355 -4.50622 8.29661 -2.9861 +517 1 9.11865 12.5108 8.02933 -49.9881 -7.42173 -16.2711 +518 2 9.47674 11.8107 7.47486 8.95817 -5.21768 -2.38673 +519 2 8.15231 12.5395 7.74329 38.6911 2.79466 15.4325 +520 1 1.1334 1.67756 2.81686 3.27117 15.7614 -6.58164 +521 2 0.957986 2.31477 2.10151 -6.66947 -14.3695 3.78127 +522 2 1.78538 2.12055 3.36586 -0.578909 1.22693 6.40118 +523 1 4.20106 15.0562 10.0364 -13.4085 1.18971 -5.18923 +524 2 3.93003 15.0868 9.10675 3.70212 3.27773 4.96515 +525 2 5.05647 14.6363 10.0432 10.3336 -3.36269 -1.32379 +526 1 7.40784 2.22679 14.822 -4.38879 4.63456 3.27925 +527 2 7.05629 1.62422 14.1639 1.19517 -1.6595 -3.72526 +528 2 7.83793 2.94849 14.3413 -6.72155 -4.85002 1.32971 +529 1 18.3301 14.5327 2.1542 24.8671 -25.4621 4.78212 +530 2 0.57397 14.7195 2.50861 -8.4973 4.51839 -6.64425 +531 2 17.8578 15.3422 2.05909 -12.5294 22.9533 -1.13776 +532 1 10.0489 2.71902 12.9028 6.85621 -14.8278 -12.6664 +533 2 9.96638 2.08865 12.1549 1.47254 10.1846 11.5218 +534 2 9.24995 3.25129 12.8895 -2.74325 3.95657 -0.856162 +535 1 2.95855 8.84401 12.9769 -19.5266 -12.9618 -2.46154 +536 2 3.45638 9.64099 12.8192 4.11354 12.8609 -3.4499 +537 2 3.6113 8.17746 13.175 10.7686 -6.78904 5.39462 +538 1 3.18595 8.60313 3.78164 6.49512 -8.67182 57.5105 +539 2 3.58728 9.20701 3.1814 16.1034 15.9636 -13.6327 +540 2 3.51933 8.8716 4.70776 -18.429 -13.2453 -44.8458 +541 1 5.73851 7.25721 8.5964 -4.13987 -1.96532 11.6754 +542 2 5.69005 6.29369 8.53393 1.30439 2.87011 -1.70973 +543 2 5.04632 7.51192 9.22575 1.66035 -1.11756 -5.95213 +544 1 14.9081 1.62503 1.83745 -8.73365 -28.3512 -14.8102 +545 2 15.1675 2.29904 2.4498 2.46531 19.8996 4.15138 +546 2 15.1848 1.81402 0.924567 6.2551 4.83326 15.3454 +547 1 8.63912 15.0489 0.67096 1.85438 -3.84451 5.87273 +548 2 9.43742 14.948 1.21756 -6.6173 4.03251 -1.68679 +549 2 7.96284 14.4978 1.10066 2.22069 5.93818 -4.9944 +550 1 15.4364 1.44293 7.19944 -29.9197 -3.33934 -17.0244 +551 2 14.7125 0.994492 6.68707 24.0317 7.87524 16.0302 +552 2 15.0797 2.33705 7.33252 4.46076 -6.95989 4.74521 +553 1 4.93029 12.8913 18.4644 10.9792 1.21933 18.1223 +554 2 5.27563 12.987 0.740174 -6.01723 -1.47567 -19.726 +555 2 5.68015 13.1369 17.9044 -5.07302 3.16897 2.74711 +556 1 15.3923 8.68146 18.054 15.694 19.9465 -16.5309 +557 2 15.9315 9.21769 17.4147 -18.0717 -17.5644 15.7946 +558 2 15.1857 9.29971 0.121687 -1.56315 -2.75746 2.59172 +559 1 11.9784 3.14039 18.3403 11.1408 -7.29272 18.8649 +560 2 12.1001 2.9975 0.653392 -4.70819 -0.503108 -12.7749 +561 2 12.4778 2.40933 17.9385 -7.35096 7.48199 -3.86664 +562 1 13.1896 12.7267 5.18606 4.81883 -3.59528 0.0329893 +563 2 13.4958 11.8346 4.97314 2.3467 3.28367 -0.068752 +564 2 13.4618 12.8881 6.09814 -4.13789 -2.12194 -0.520265 +565 1 6.18108 7.13483 0.245639 -8.98659 -24.3205 -5.24363 +566 2 6.15368 8.0627 19.0493 5.02048 26.2765 -0.395042 +567 2 5.28324 6.84248 0.444666 1.40419 -2.69741 2.9636 +568 1 17.7469 15.8806 14.9091 -16.6307 4.82259 1.60218 +569 2 16.7811 16.0196 14.9781 16.1488 -1.66255 -6.01934 +570 2 17.9228 15.7652 13.9648 -0.217809 -0.705292 2.49903 +571 1 13.1074 0.925484 16.7107 3.18003 -6.63181 9.52558 +572 2 14.0398 0.701227 16.9047 -10.9319 3.14101 -7.94235 +573 2 12.6435 0.0729893 16.6565 6.11054 4.53406 -2.82687 +574 1 10.8779 14.5049 7.42771 23.1657 22.4115 -16.2389 +575 2 10.1426 13.9786 7.6854 -20.2069 -15.6201 11.4355 +576 2 11.6544 13.9411 7.50544 0.873985 -2.97227 1.69423 +577 1 17.7332 8.41688 2.16357 9.83329 25.3003 13.1733 +578 2 16.8474 8.49196 2.51389 -11.5025 -5.56634 1.51969 +579 2 17.684 7.86174 1.40275 -6.79002 -17.3841 -17.6814 +580 1 12.5241 7.78132 2.0423 -1.44154 17.0415 -14.1456 +581 2 12.3356 8.69211 1.74465 0.56853 -10.9135 10.1338 +582 2 12.0507 7.22418 1.41137 4.13261 -1.84431 -3.3422 +583 1 12.0402 14.5123 10.5082 -18.3289 -2.04433 -49.0296 +584 2 12.3885 14.3833 9.58045 -11.5085 2.39427 35.0464 +585 2 11.0712 14.6752 10.3612 24.5139 -2.29095 9.58119 +586 1 6.7433 6.75035 15.5111 8.69017 25.9379 21.8943 +587 2 7.64047 7.11596 15.2998 -22.3365 -16.355 4.27733 +588 2 6.42641 7.26782 16.2896 9.37622 -14.6905 -17.8302 +589 1 7.9604 4.42511 13.2728 28.7823 16.7879 24.018 +590 2 7.37747 4.63038 12.5661 -23.4436 4.48442 -18.6585 +591 2 8.25373 5.30295 13.5968 -1.99494 -17.578 -1.9241 +592 1 13.2943 12.2257 14.4027 3.56556 -5.33332 1.41443 +593 2 13.2861 11.2546 14.3815 -5.78887 6.10336 -0.82645 +594 2 13.6298 12.4878 13.5348 -0.194802 0.853385 3.24808 +595 1 14.4975 9.60743 7.32851 -1.81828 -22.5371 -11.9494 +596 2 15.283 10.0905 7.53237 20.8949 12.3364 4.94663 +597 2 13.7862 10.0745 7.73482 -16.3884 10.3496 13.6544 +598 1 12.6855 16.7955 3.35468 10.446 54.0378 -9.24021 +599 2 12.8247 17.4169 4.11373 -2.43161 -22.9959 -18.5255 +600 2 12.7287 17.4093 2.56008 -5.07923 -25.2307 27.5772 +601 1 0.985851 7.00227 17.3383 1.31889 9.4813 -6.51378 +602 2 0.174673 6.82729 17.8428 -2.72668 6.21708 -7.63644 +603 2 0.788987 7.63656 16.6124 1.43967 -10.9643 14.4702 +604 1 12.9703 4.85252 15.7444 36.7131 7.67865 -11.6648 +605 2 13.7444 4.28338 15.4912 -28.1266 12.6425 14.7219 +606 2 13.3848 5.73698 15.8318 -12.3641 -9.92719 -0.136909 +607 1 2.31739 3.41657 5.06312 -13.6796 12.8802 45.0615 +608 2 1.71742 3.03519 5.77756 22.5616 7.27981 -29.9715 +609 2 2.67638 4.25091 5.49055 -8.69432 -27.9074 -22.1065 +610 1 8.14626 10.9014 13.7501 23.1519 -21.2188 51.9658 +611 2 8.18961 10.6456 14.7569 -3.14293 16.1916 -66.8861 +612 2 8.91613 10.442 13.3487 -9.38929 12.2654 3.7561 +613 1 12.9965 1.57692 13.2293 -13.236 30.2614 -33.2276 +614 2 13.5053 1.61767 12.3799 -8.92772 -10.8244 27.0208 +615 2 12.3556 2.33631 13.1194 22.5086 -26.9187 11.5847 +616 1 6.63966 13.684 2.03193 -11.5531 1.65982 24.7971 +617 2 6.01437 14.0711 2.69678 13.9712 -7.1585 -19.9778 +618 2 7.21702 13.1132 2.57076 -4.92077 5.61769 -6.96253 +619 1 15.813 6.37449 12.4855 -26.0384 -19.2076 5.56376 +620 2 16.3133 6.94665 11.9354 17.458 16.492 -16.919 +621 2 16.1081 6.5465 13.3734 10.1637 1.50607 12.5345 +622 1 16.7517 0.683836 9.54032 9.17465 -17.8268 3.86543 +623 2 16.8312 18.3701 9.76674 -11.2714 16.7378 -3.92594 +624 2 16.3182 0.76443 8.67683 0.0107679 -1.03064 0.242674 +625 1 6.19528 11.6935 8.23629 -2.98771 -55.3704 13.0415 +626 2 5.39217 11.4329 8.74625 16.1659 14.5788 -12.0119 +627 2 6.59624 10.789 8.03203 -10.8651 41.6219 1.75135 +628 1 2.78257 8.63233 0.349942 -51.0927 -6.02203 -19.4773 +629 2 2.14734 8.16991 18.3384 31.254 20.3071 31.1367 +630 2 2.20011 9.24624 0.868363 16.6862 -13.9373 -14.0055 +631 1 10.0933 10.2699 6.60791 4.69659 2.91801 -6.95173 +632 2 10.6585 9.65933 7.0984 -2.33853 -1.64778 -0.152736 +633 2 10.478 10.3114 5.71024 -7.38541 0.394324 12.3102 +634 1 6.85971 15.7454 6.78123 4.24276 8.06212 3.90305 +635 2 7.14611 16.2575 7.56121 -6.95129 -7.98507 -8.49325 +636 2 7.04221 16.3283 6.02778 -2.00154 -5.2395 1.03704 +637 1 6.5672 12.9167 5.89107 0.597921 -4.77378 -3.41809 +638 2 6.75629 13.7931 6.22612 0.282518 9.70238 2.49815 +639 2 6.16516 12.4266 6.61937 1.75727 3.9196 -1.62353 +640 1 16.7395 12.5246 9.74847 -3.06854 -10.3396 -13.3378 +641 2 16.803 11.7934 9.09918 0.0574675 11.3505 13.7779 +642 2 17.2471 13.2388 9.35461 0.0307086 0.265441 4.69208 +643 1 6.27963 2.83254 2.76143 -4.73524 -28.0523 14.6006 +644 2 6.37898 3.73989 2.5277 5.16678 22.951 -10.7112 +645 2 5.79937 2.39077 2.0523 -0.657158 4.14199 -3.99187 +646 1 10.6834 2.9997 3.2493 -4.30343 6.66703 3.45031 +647 2 10.3389 3.87773 3.47337 -2.10815 -7.43082 -2.74741 +648 2 10.1644 2.67816 2.50044 1.52937 0.706493 -1.87803 +ITEM: TIMESTEP +100 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.77244 6.59569 17.9763 -3.45079 -15.6041 -9.13306 +2 2 7.88004 6.49722 18.3444 6.65526 3.83231 -3.73646 +3 2 8.88832 5.875 17.3232 0.339998 10.7344 11.2284 +4 1 0.232197 8.43163 6.74931 6.06809 -9.75314 40.4456 +5 2 0.255717 8.25928 5.82997 0.568886 -7.03857 -37.2819 +6 2 0.690537 7.6579 7.15764 -12.6716 20.3857 -3.7924 +7 1 8.73054 0.448274 6.96197 0.757688 5.19807 -2.99354 +8 2 9.64384 0.493158 6.62895 -11.5479 0.592924 -0.0248858 +9 2 8.1978 0.998025 6.35807 9.15448 -7.13553 5.61176 +10 1 6.40593 1.75267 11.8149 38.8296 -3.08614 -8.28972 +11 2 5.81968 2.38515 12.1727 -25.8813 19.5399 13.38 +12 2 5.91601 0.958217 11.6787 -14.9693 -21.4487 -5.83463 +13 1 6.93553 5.46707 2.3717 -29.4847 3.29264 10.9289 +14 2 6.2293 5.77948 3.0367 33.3819 -5.43232 -34.2308 +15 2 6.73101 5.82483 1.47662 0.276644 1.33511 28.97 +16 1 16.2706 10.1725 16.0328 16.576 -12.0275 -13.9735 +17 2 17.1689 10.3287 15.6909 -13.6837 1.56601 5.28727 +18 2 15.9002 11.0264 16.2303 -5.40144 13.1923 2.47446 +19 1 10.8573 14.9713 2.3127 -4.53536 -0.807355 -13.4682 +20 2 10.8458 14.5197 3.15612 -3.95698 -5.41896 6.20362 +21 2 11.2908 15.8056 2.48855 3.23834 4.77246 6.19277 +22 1 17.2232 8.21136 11.0033 2.73792 2.45641 -7.11401 +23 2 16.6726 8.88418 11.4331 2.86084 -2.93597 -0.581414 +24 2 17.9525 8.69866 10.5809 -6.6523 -2.55116 4.88578 +25 1 14.5937 16.0509 16.2923 16.8919 1.55785 -12.0612 +26 2 13.6919 16.3738 16.3176 -7.99874 0.738503 2.77307 +27 2 14.7362 15.4806 17.0483 -6.38665 -4.70858 10.3974 +28 1 12.1782 13.2488 0.556058 -6.41896 9.17153 -4.9038 +29 2 11.8393 13.4134 18.3136 3.64438 -6.73296 -6.87976 +30 2 11.6781 13.8768 1.08938 4.30308 -0.940018 9.70193 +31 1 9.32636 5.50189 3.85673 -23.6707 -6.9557 11.6523 +32 2 8.85207 5.35955 4.73387 10.6863 3.91607 -36.7024 +33 2 8.65492 5.41152 3.1282 11.356 3.18621 25.5004 +34 1 1.53424 3.89903 11.544 -4.66799 23.5976 14.1629 +35 2 1.33558 4.79151 11.9229 9.77101 -18.0042 -9.49869 +36 2 1.78943 3.33535 12.2834 2.68741 0.460061 1.88957 +37 1 2.11036 6.99869 8.11066 2.48315 -17.2899 2.96853 +38 2 2.57184 7.49315 8.78305 3.29023 12.1045 5.89357 +39 2 2.1177 6.10606 8.48449 -3.4025 -1.3508 -8.01694 +40 1 5.18347 4.46977 7.78792 -2.57538 4.03359 -5.12796 +41 2 5.37117 3.51932 7.65443 -4.82345 11.4027 -0.558597 +42 2 4.53495 4.79047 7.12216 11.4175 -13.4448 8.55636 +43 1 3.42716 2.88114 17.3924 1.12201 37.8538 -2.09818 +44 2 4.03218 3.21565 16.6954 -8.80258 -2.8612 13.6459 +45 2 2.96175 3.68375 17.7714 12.3959 -28.5801 -12.8282 +46 1 7.56049 5.45137 6.19682 -11.2764 11.7759 39.3451 +47 2 8.17338 6.02323 6.733 -17.9712 -15.9787 -15.2388 +48 2 6.83707 5.19934 6.84169 25.8687 -1.03041 -23.6459 +49 1 9.81873 7.03274 12.0818 18.6926 1.80354 21.1658 +50 2 10.1168 6.17447 11.801 2.37707 -8.57843 -5.75387 +51 2 9.13705 7.28384 11.4839 -21.9155 5.9942 -18.2818 +52 1 13.9782 3.81734 8.11005 -6.38125 -7.14222 -11.0636 +53 2 13.4268 4.53125 7.77431 4.97705 1.71109 -4.47031 +54 2 14.3288 4.12395 8.93436 6.50574 7.00298 17.9277 +55 1 4.54162 17.1358 3.87887 10.9044 35.7056 -0.341992 +56 2 5.36932 17.5648 4.19271 -11.2647 -17.0231 -6.60056 +57 2 4.14672 17.8103 3.27983 -0.0256371 -21.9717 9.98561 +58 1 16.2123 16.5489 10.6095 26.1835 -5.76397 -19.4616 +59 2 15.4589 16.7003 11.1416 -23.8325 7.35421 23.2226 +60 2 15.8886 15.8767 10.0022 2.98718 1.98497 -7.14015 +61 1 1.93449 4.79928 0.00082377 17.3961 -4.98991 5.57961 +62 2 2.67896 5.07161 0.592242 -22.0191 7.26131 -10.4701 +63 2 1.68005 5.53286 18.0583 5.78187 -2.17332 10.5029 +64 1 11.1761 13.3033 16.4476 20.6858 -29.5101 -20.5449 +65 2 10.7502 12.4348 16.5818 -0.505604 15.8506 2.04497 +66 2 11.8189 13.0874 15.7254 -14.483 14.0049 15.9552 +67 1 10.0082 10.9133 16.7377 -9.76065 -12.5647 6.43928 +68 2 10.4104 10.0696 17.0143 -3.0625 14.8211 -5.5238 +69 2 9.04798 10.758 16.6751 14.6534 4.77532 0.819581 +70 1 11.8926 17.5507 13.5059 -15.5524 -14.4544 -0.25773 +71 2 12.4585 17.1847 12.8152 4.41482 5.53476 3.60851 +72 2 11.9755 18.5016 13.5139 9.00416 11.9454 -7.12981 +73 1 6.39659 9.54323 12.3526 -12.6063 6.46711 4.93213 +74 2 6.97402 9.29797 11.635 9.25294 -5.21247 -6.5221 +75 2 6.9248 10.0607 12.9773 -1.49192 -5.83682 -8.37915 +76 1 16.2827 12.8664 2.8283 0.430065 -24.2056 0.300325 +77 2 17.1271 13.2094 2.55074 10.9303 3.80489 0.0707423 +78 2 15.7284 13.6342 2.87288 -15.0446 12.1841 2.12753 +79 1 0.782434 12.8185 5.85612 -33.4557 3.27495 -26.778 +80 2 1.12737 12.9122 4.94214 -3.16706 -8.15793 13.9432 +81 2 18.4302 12.7528 5.74133 33.3816 -1.67566 5.80796 +82 1 5.29416 16.3645 18.462 -0.365113 -1.85929 1.37874 +83 2 5.65117 15.5929 17.9841 -1.41418 12.24 9.00358 +84 2 5.90904 16.5787 0.535619 -2.78951 -3.81837 -4.76209 +85 1 0.717617 7.68269 4.16298 45.78 12.5398 -25.9452 +86 2 0.140595 7.95484 3.42088 10.68 -3.85526 14.32 +87 2 1.67421 7.98176 3.89702 -61.12 -15.169 17.2669 +88 1 3.20538 9.16537 6.53153 -16.7997 -26.3462 11.633 +89 2 3.63886 8.66012 7.25517 -10.7634 14.1338 -16.8685 +90 2 2.28456 8.785 6.4428 29.8979 17.6904 5.8263 +91 1 7.3492 10.4558 16.1821 -32.1717 -5.51262 30.2531 +92 2 6.6595 11.1272 16.0448 13.9154 -6.26319 -1.99334 +93 2 7.03952 9.99344 16.9918 7.69449 10.9592 -10.5833 +94 1 10.9926 0.857119 5.02234 -5.32556 5.69944 -21.4369 +95 2 11.0071 1.72344 4.58448 5.20867 -2.07691 11.6276 +96 2 10.6449 0.320945 4.28448 4.96755 -3.65716 14.4683 +97 1 4.17972 2.99732 13.1563 8.08367 -30.8511 5.02994 +98 2 4.53886 3.3528 13.9956 -8.94088 -10.2248 -10.148 +99 2 4.12323 1.98418 13.2207 2.50903 42.0947 6.54014 +100 1 8.52337 10.2728 1.80778 10.3789 -10.908 24.8689 +101 2 8.43412 10.9106 2.54849 -2.4679 -8.46295 -11.8092 +102 2 8.72683 9.4118 2.24878 -4.48166 20.4458 -7.62428 +103 1 10.3146 1.66303 15.4651 0.0280032 6.46587 3.16016 +104 2 11.2365 1.5769 15.7049 7.71736 -2.87845 -0.628854 +105 2 10.2832 2.03916 14.5766 -0.873711 -2.30994 -1.44208 +106 1 2.60872 12.9688 7.93078 -1.0685 2.90827 1.70102 +107 2 3.08524 13.7852 7.70925 1.81136 -8.54773 -5.41906 +108 2 2.07592 12.7429 7.1537 2.1601 3.22826 4.8584 +109 1 3.84139 11.714 4.98357 -9.2182 -6.48315 2.00023 +110 2 3.59649 11.1336 5.73363 3.13206 7.92599 -15.0555 +111 2 3.08391 11.75 4.36582 7.48234 -0.753218 11.1676 +112 1 6.65636 14.539 16.9808 1.14971 -3.74934 -0.345026 +113 2 7.45699 15.0461 17.1534 0.734042 -3.82079 -1.22553 +114 2 6.35462 14.7758 16.0963 4.10604 -0.420587 -1.60546 +115 1 14.2186 14.4753 3.18712 8.31434 -1.03143 -11.3814 +116 2 13.7635 15.2982 3.34662 -3.59872 10.6386 -1.06184 +117 2 13.8465 13.8568 3.80574 -6.38377 -9.35153 11.7656 +118 1 8.76639 18.036 16.1575 -17.2352 -7.71273 4.18589 +119 2 9.29865 17.253 16.446 -1.99578 26.3863 -16.3924 +120 2 9.21082 0.13577 15.7005 10.7734 -16.3176 12.3305 +121 1 4.70057 1.84937 4.90583 -5.59427 22.8387 -36.2464 +122 2 3.793 2.25175 4.86575 28.8401 -10.2604 4.23254 +123 2 5.1801 2.18711 4.08016 -18.9233 -12.3263 38.2061 +124 1 15.0501 12.6021 16.5687 -12.0311 0.26828 5.88874 +125 2 14.6786 12.8761 17.4109 9.53333 3.55003 6.01908 +126 2 14.2645 12.5148 16.0221 4.98358 -1.43573 -15.5641 +127 1 15.7004 18.5129 16.8573 39.713 -3.42746 23.3516 +128 2 16.4681 18.7143 17.5055 -38.5977 -15.0096 -30.817 +129 2 15.6109 17.5396 16.7903 -2.54574 14.9499 6.02131 +130 1 1.36802 1.35817 16.6529 -7.19601 7.74866 13.6684 +131 2 2.15913 1.86948 16.876 -3.57304 -8.28302 -6.01627 +132 2 0.751389 1.61649 17.3659 4.93092 -7.13328 -12.7379 +133 1 18.2443 4.33431 15.8699 4.87602 -2.4936 -15.9817 +134 2 17.8369 3.63124 15.3424 2.32992 6.4949 4.25729 +135 2 0.452078 4.51482 15.4394 -9.42811 -2.49011 8.2103 +136 1 12.0529 17.1173 16.1421 -28.5646 -13.5401 15.8604 +137 2 11.3287 16.6705 16.6559 24.6179 11.2855 -13.6919 +138 2 11.708 17.1501 15.239 10.7504 0.848438 1.34073 +139 1 16.0751 2.69533 18.2299 -16.8426 22.7601 -19.9608 +140 2 15.7518 3.52741 18.6545 8.16925 -19.768 -14.2608 +141 2 15.768 2.75869 17.2894 6.47211 -5.43997 24.4047 +142 1 6.70105 13.7211 10.0493 -2.92253 -3.29615 13.924 +143 2 6.49616 13.3451 10.9223 2.46715 2.87816 -3.90822 +144 2 6.5701 13.0016 9.42848 5.58743 -2.71244 -4.10916 +145 1 10.1642 18.4563 2.66846 -6.4553 9.35236 -16.0973 +146 2 10.4494 0.522706 2.05557 -0.598662 -14.7868 7.93587 +147 2 9.23943 18.2921 2.43567 5.35466 0.524311 4.08806 +148 1 3.08905 17.6286 6.23363 28.1073 -1.15148 23.9606 +149 2 2.19758 17.5876 5.91536 -10.6529 4.22104 -18.8026 +150 2 3.7136 17.7221 5.50184 -12.297 -3.14114 -7.6924 +151 1 12.6187 16.7784 7.83399 -8.24743 2.38577 1.37984 +152 2 11.9273 16.0794 7.74003 7.37944 21.7069 5.85683 +153 2 12.3535 17.4638 8.48865 -0.622135 -17.7991 -6.24189 +154 1 14.8741 15.2807 8.33754 11.6667 3.93031 -5.87838 +155 2 14.2607 15.9458 8.0029 -4.6938 -2.09697 8.01324 +156 2 15.5465 15.2244 7.63778 -8.32879 0.363275 5.25782 +157 1 17.8358 18.3077 0.207666 -46.6557 3.82667 -12.4063 +158 2 18.5381 17.6928 0.20107 34.3258 -19.0599 -1.41311 +159 2 18.1099 0.429917 0.68066 12.6369 19.0779 11.4558 +160 1 0.768971 10.519 1.45234 -14.3967 -19.3664 19.1268 +161 2 -0.0407552 10.0454 1.78172 23.5075 9.70284 -14.2764 +162 2 0.503185 11.1892 0.827858 -7.10365 8.12718 -9.46819 +163 1 1.82037 12.3064 3.2607 -0.411525 2.12628 17.6018 +164 2 1.36119 11.682 2.70611 -2.67447 -10.2614 -7.1426 +165 2 2.03731 13.0482 2.69872 0.079619 5.20365 -3.96737 +166 1 0.725717 17.3003 4.98992 32.4002 3.58468 -34.9181 +167 2 -0.000639544 17.8885 5.08952 -19.7566 14.3988 12.6832 +168 2 0.713313 16.5777 5.58791 -15.4184 -21.9192 25.4801 +169 1 0.951486 0.797441 9.37101 14.826 11.188 -16.0996 +170 2 1.14791 0.588384 10.2838 -3.41112 -8.44303 11.2353 +171 2 0.0745467 0.497625 9.13864 -8.88294 -4.64793 9.22513 +172 1 16.8073 2.38946 13.4769 5.39787 -10.4284 -8.99471 +173 2 17.0506 2.69304 12.5747 -8.0967 -7.05722 13.8788 +174 2 16.5161 1.45381 13.4188 4.66162 13.0486 -2.08534 +175 1 2.62912 16.0502 12.0784 8.40953 -12.472 -10.7904 +176 2 3.04385 15.7269 12.8881 -2.37218 0.184289 -5.79457 +177 2 3.10949 15.6337 11.3228 -8.7582 6.42497 16.6586 +178 1 16.3457 15.4302 6.12389 30.9011 24.8554 -18.1041 +179 2 17.2992 15.5349 6.36757 -22.0844 -7.23183 -0.993592 +180 2 16.19 16.1865 5.50068 -1.85714 -20.6143 14.9819 +181 1 5.77873 5.21745 11.785 11.0193 -20.9315 -11.6683 +182 2 5.50793 5.92484 12.3546 -4.36629 16.5013 7.19057 +183 2 5.27867 4.45162 12.0794 -6.37659 -1.59945 -1.70387 +184 1 15.1747 4.94504 0.761547 -29.5175 -4.13494 28.6724 +185 2 14.9952 4.57194 1.67189 6.69018 16.901 -24.5633 +186 2 14.3176 5.30548 0.449447 18.0211 -8.94221 4.63226 +187 1 16.4144 16.461 1.77501 8.34865 -5.69196 -8.65308 +188 2 16.356 16.7636 2.67626 -8.71628 3.92983 13.8981 +189 2 16.7832 17.2073 1.29403 -0.614878 1.7319 -3.63708 +190 1 0.136057 4.8659 3.98965 34.6037 22.2365 -2.60366 +191 2 0.554963 5.79058 3.9624 -19.788 -38.6093 6.27627 +192 2 0.840291 4.21253 4.20207 -10.6708 20.7839 -4.14843 +193 1 2.91044 15.0804 15.1041 7.34684 -10.5058 14.2682 +194 2 2.90482 14.7198 16.034 -7.41786 16.0657 -24.8201 +195 2 2.46761 15.9418 15.099 -2.49045 -2.68752 9.6724 +196 1 0.98952 14.6361 9.40184 3.41519 -3.90395 6.55514 +197 2 1.54705 13.945 9.00075 -6.08548 3.23571 10.1521 +198 2 0.78947 14.3674 10.3125 0.535168 -4.82993 -11.1122 +199 1 13.5676 16.5089 11.5672 -19.673 9.58551 -20.9583 +200 2 13.2883 17.2623 10.9814 5.35041 -18.2182 15.9177 +201 2 13.0352 15.7491 11.2513 9.15027 7.77217 2.32965 +202 1 4.84709 1.60354 0.665871 -13.2454 -7.94988 -14.2061 +203 2 4.37724 2.10746 -0.0295305 4.1335 -5.07179 15.4313 +204 2 4.23428 0.890311 0.93575 7.29231 10.3056 3.49355 +205 1 1.57562 18.6232 11.9448 -9.54215 3.4719 -19.1533 +206 2 1.53947 0.452662 12.7669 0.622104 8.67092 13.3018 +207 2 1.94164 17.7639 12.1401 7.67295 -5.68018 1.31967 +208 1 11.3828 10.0809 4.23132 25.5406 -0.783734 -33.5194 +209 2 11.2477 10.3841 3.29047 7.40472 -5.62792 30.1478 +210 2 12.3604 9.90108 4.31318 -36.068 9.82931 1.34024 +211 1 8.1924 12.225 3.79726 -5.69748 14.5101 56.1678 +212 2 9.05523 12.5573 4.13122 -12.2475 -6.42112 -18.1901 +213 2 7.61811 12.3317 4.63279 18.664 -10.6547 -44.172 +214 1 14.6446 4.04033 3.3856 3.29585 4.20735 14.8065 +215 2 15.1799 4.13354 4.21231 -10.8641 -1.34483 -21.0767 +216 2 13.7289 4.27483 3.60977 8.83721 -0.102893 1.13309 +217 1 5.73789 1.70847 7.633 -45.2268 -33.2589 19.0394 +218 2 5.00558 1.12579 8.07813 40.2552 34.7696 -21.6936 +219 2 5.52319 1.67762 6.69069 2.06189 0.609235 -2.30714 +220 1 17.8554 0.94247 4.83325 2.84508 1.94772 -6.32822 +221 2 18.4375 1.13729 4.06994 -6.68522 3.20321 14.3473 +222 2 17.8361 1.70281 5.4359 2.52705 -5.98387 -7.60558 +223 1 6.82607 9.13014 4.53731 -2.03949 -2.27606 -0.824268 +224 2 6.749 9.37751 5.45829 -4.27203 4.05265 7.19029 +225 2 7.76352 8.95198 4.44117 4.86868 -1.78157 -6.05796 +226 1 2.39805 14.6397 2.05874 17.0918 -1.49078 4.46086 +227 2 3.17145 14.6314 2.66377 -10.8679 0.525641 -12.6634 +228 2 2.72903 14.4183 1.17543 -1.81421 4.03234 5.90777 +229 1 17.1796 12.9575 13.0281 -10.0626 2.91445 0.0973403 +230 2 16.3048 13.3397 13.2675 20.7192 2.62525 -4.36947 +231 2 17.7682 13.6617 12.6978 -15.1419 2.46765 5.43564 +232 1 14.7925 10.5715 1.51204 -8.6843 -36.4521 -19.1925 +233 2 15.3686 11.2103 1.85793 27.186 33.4644 17.5702 +234 2 13.9217 10.9161 1.62765 -18.2001 7.18743 0.677482 +235 1 5.63756 6.65584 4.53835 -5.70194 -14.7917 8.95129 +236 2 5.96892 7.55557 4.50237 4.06113 5.5935 -1.33512 +237 2 6.19689 6.19506 5.18786 2.48768 6.43185 -8.34619 +238 1 8.1035 8.32015 10.3633 -6.06951 -1.51391 13.5103 +239 2 8.71051 8.88696 9.88772 3.75134 6.39998 -5.242 +240 2 7.4427 8.01108 9.7382 -0.891776 -1.59521 -4.95879 +241 1 13.4554 18.4382 5.64567 -23.0826 -2.6609 26.3697 +242 2 12.6541 0.350227 5.51512 12.1971 -9.37205 -2.29397 +243 2 13.2308 17.8847 6.43702 5.12544 9.06169 -21.995 +244 1 0.0481459 2.53289 0.450073 0.762545 20.3906 -8.36614 +245 2 17.7393 2.57826 18.829 23.3906 9.65711 1.86789 +246 2 0.50996 3.41343 0.303855 -21.6669 -27.8541 1.68488 +247 1 12.9745 10.8048 9.65469 -32.5048 41.5261 -13.285 +248 2 12.0083 11.0976 9.65119 33.8953 -25.1931 3.11551 +249 2 13.0333 9.87229 9.85209 -8.8072 -6.07099 4.09073 +250 1 0.527116 12.3319 11.2575 10.4347 -0.622496 2.4881 +251 2 18.2313 12.2915 11.4294 -10.2968 -1.46033 -6.74513 +252 2 0.909084 12.5363 12.117 7.12796 0.366826 -3.41572 +253 1 5.28415 7.34725 13.2845 -6.32664 2.65038 2.55184 +254 2 5.64713 8.17412 12.9655 4.82658 4.12789 -9.57053 +255 2 5.74627 7.2293 14.1116 0.316635 -7.58532 9.69513 +256 1 1.16454 6.74183 12.03 -13.1625 -42.3004 -9.02199 +257 2 0.295417 6.98712 11.7254 -9.09418 5.46945 -3.0829 +258 2 1.57891 7.53521 12.2772 19.8541 36.5775 12.6901 +259 1 15.5783 9.75012 12.4577 9.71681 16.8235 16.5595 +260 2 15.2431 10.6351 12.2158 0.950441 -15.6258 3.07953 +261 2 16.0853 9.89705 13.2804 -12.0519 -4.92211 -13.1427 +262 1 16.5993 12.6285 5.60521 -10.2494 37.6021 -45.7262 +263 2 16.4242 13.6113 5.62967 5.67224 -29.3823 14.3376 +264 2 16.441 12.4706 4.63081 7.92181 -5.25591 31.2114 +265 1 6.41284 9.90681 0.119653 0.515871 -10.7086 -9.9123 +266 2 5.64934 10.3727 0.465056 -3.06655 2.33505 3.46562 +267 2 7.14462 10.1266 0.702846 2.16363 1.41956 4.36049 +268 1 12.2095 5.93838 4.00309 -11.5544 -2.90268 -3.08172 +269 2 12.2942 6.66752 3.37735 2.08742 0.382808 1.33145 +270 2 11.2587 5.74648 4.01779 6.74513 0.670066 1.17813 +271 1 0.342924 12.9268 0.00967172 -2.71894 -2.13654 5.95194 +272 2 18.7348 13.4393 0.793746 3.88983 0.588143 -5.53597 +273 2 18.4589 13.2921 17.9296 1.41778 -5.28425 5.34754 +274 1 3.57599 18.7244 8.67011 -7.57313 7.8026 -17.3863 +275 2 3.53053 18.3214 7.79351 4.94999 -5.98969 2.51912 +276 2 2.6975 0.472694 8.72681 1.72246 -0.921876 11.7862 +277 1 7.19816 17.4543 4.42938 13.0422 27.6578 -13.842 +278 2 7.51541 18.3714 4.6455 -6.70989 -26.1973 -6.43912 +279 2 7.34255 17.3635 3.4592 -3.95356 0.0926602 20.0901 +280 1 9.24276 17.181 12.1874 27.1924 -9.91753 -12.8104 +281 2 9.16544 16.536 11.4403 4.06483 10.4089 22.9332 +282 2 10.1989 17.1789 12.4847 -33.3611 -0.423317 -5.22003 +283 1 13.2427 13.2324 7.99028 -4.63127 -11.2433 10.7708 +284 2 13.2975 12.5097 8.63573 0.309708 1.2863 -7.28868 +285 2 13.9184 13.8596 8.25103 7.01778 4.96536 -0.211076 +286 1 14.7706 2.86972 15.5058 12.3246 -20.976 -18.3849 +287 2 14.0341 2.28041 15.2496 10.8751 5.18171 6.07562 +288 2 15.4548 2.72916 14.8136 -15.3015 9.06101 10.4071 +289 1 9.96013 15.6554 16.9624 -0.416257 -4.3558 -3.6035 +290 2 10.3061 14.8055 16.6414 -1.75696 6.53817 2.71112 +291 2 9.61308 15.4752 17.8389 -3.07369 -3.40172 1.73448 +292 1 11.2206 8.54091 16.6271 11.2119 0.246209 -0.153837 +293 2 10.3853 8.13843 16.425 -12.7378 -7.75768 -8.20822 +294 2 11.7159 7.85532 17.0695 3.92811 -4.5145 7.83184 +295 1 4.19128 18.3534 16.7936 -2.0541 -15.6573 2.75359 +296 2 4.49896 17.6946 17.4386 1.3239 2.14246 -6.87061 +297 2 4.3476 0.553135 17.2025 -0.294224 9.43754 2.6314 +298 1 2.38271 4.321 8.90759 20.0465 -16.3105 29.2362 +299 2 3.33364 4.03277 8.87737 -27.5446 13.4253 -3.78204 +300 2 2.08958 4.1083 9.83354 7.71669 6.29647 -26.7475 +301 1 9.9842 10.4369 9.88352 -17.0195 21.6351 -0.0387615 +302 2 9.44133 11.1731 9.47934 17.4922 -21.0458 18.4718 +303 2 9.94225 10.4854 10.8652 2.27572 1.94662 -18.6097 +304 1 9.85899 0.920399 10.8075 0.162278 -2.63975 1.09763 +305 2 9.48302 0.0750215 11.0855 -2.58178 2.3482 3.77053 +306 2 9.21377 1.33985 10.2254 -0.0206645 -1.54215 -2.59695 +307 1 9.16055 15.229 10.2075 -19.4407 -6.65372 -14.862 +308 2 8.92137 15.8821 9.51239 -0.317996 -13.1788 14.0466 +309 2 8.43697 14.5477 10.1944 18.1534 21.6077 -0.815821 +310 1 0.71674 9.75329 10.1461 2.10813 23.2969 8.50765 +311 2 0.819344 10.7283 10.3167 -3.94998 -28.3852 -4.44668 +312 2 1.15296 9.53542 9.32246 0.728257 4.55427 -3.87479 +313 1 17.2456 4.88922 8.01698 -15.6269 -0.477795 25.7007 +314 2 16.4423 5.19943 8.52213 28.7194 -9.29348 -15.89 +315 2 17.7804 4.31587 8.60398 -15.5446 9.64156 -7.98894 +316 1 14.822 14.6129 0.044879 1.26259 -7.26488 27.1569 +317 2 15.5503 14.8635 0.654609 -16.5042 1.70925 -13.2775 +318 2 14.1019 14.3181 0.644441 11.2495 5.19015 -13.4399 +319 1 3.93398 11.151 9.56657 -13.0999 1.1143 6.92396 +320 2 3.8819 11.1389 10.5379 -0.108421 8.58768 -6.25849 +321 2 3.2885 11.8101 9.24754 8.95434 -7.44407 0.420275 +322 1 11.481 10.7372 1.49136 -12.2308 11.5287 -6.19882 +323 2 11.6479 11.6347 1.11375 -3.03535 -20.3842 8.82813 +324 2 10.5208 10.5745 1.38561 13.1816 3.92224 -1.496 +325 1 13.1382 7.21836 12.5396 -14.3564 7.08975 0.177427 +326 2 14.0771 7.12045 12.4061 13.875 -7.92794 3.07029 +327 2 12.7619 6.3345 12.5945 1.25366 -4.42296 3.81153 +328 1 9.68698 1.99848 0.824055 10.3256 0.727137 24.2023 +329 2 8.81917 1.78721 0.50968 -15.0497 -1.62599 -5.65 +330 2 10.155 2.38703 0.0980655 8.32187 5.69202 -13.7925 +331 1 10.602 13.3929 4.55586 17.4753 0.473987 25.0493 +332 2 11.4671 12.9458 4.66597 -13.9744 4.33191 -5.6004 +333 2 10.4831 13.8198 5.42698 -1.33045 -1.26907 -13.5894 +334 1 14.5505 1.55995 10.9504 0.793491 3.39408 -6.18689 +335 2 15.3506 1.17936 10.5364 -11.0229 12.1378 4.59402 +336 2 14.5582 2.53024 10.8225 7.4254 -12.0179 1.55597 +337 1 14.4508 12.0407 11.6074 10.4267 -5.99888 -36.1251 +338 2 15.2905 12.2256 11.0848 -31.5625 -1.98982 15.431 +339 2 13.8033 11.6041 10.9773 26.0423 16.8772 21.3357 +340 1 8.16091 5.15464 9.81808 -31.1733 -3.04727 19.1057 +341 2 7.28259 5.21015 10.2725 23.9466 4.77499 -10.0641 +342 2 8.23945 4.21356 9.63446 4.25293 -1.90524 -4.29988 +343 1 1.57078 16.9857 18.5145 2.11582 4.65495 -1.34384 +344 2 1.81738 17.3492 17.6562 0.32294 -2.46744 1.69741 +345 2 1.87051 16.0745 18.5076 0.982883 -4.60963 -1.80737 +346 1 1.40224 17.4231 15.3612 30.835 -28.8708 -16.9337 +347 2 1.58171 18.2262 15.8024 1.01568 35.607 16.5514 +348 2 0.474852 17.284 15.3634 -28.8421 -6.17683 0.802216 +349 1 3.44554 5.70547 6.04619 4.62282 22.475 -0.524537 +350 2 3.1428 6.44974 6.61309 0.90031 -17.6364 -10.4242 +351 2 4.06586 6.09018 5.39907 -5.11167 -0.757253 7.03456 +352 1 12.635 9.5385 14.2471 10.4135 -57.691 -2.75625 +353 2 13.0561 8.75521 13.7543 -17.7171 41.3381 15.7803 +354 2 12.3533 9.10151 15.082 0.88858 17.3566 -13.7461 +355 1 4.11217 15.1814 7.19429 24.0597 14.9458 -6.20919 +356 2 3.65166 15.9525 6.80506 8.00815 -8.18076 7.53786 +357 2 5.09537 15.3539 7.08579 -34.9804 -3.92885 1.78443 +358 1 0.830872 8.84313 15.1657 1.50937 4.0339 -6.81168 +359 2 0.547306 9.77972 15.0966 9.11455 -14.6477 -1.64448 +360 2 1.6109 8.72602 14.589 -11.0561 6.95599 3.23137 +361 1 12.8981 8.26079 10.0923 10.5692 -21.7103 -4.02448 +362 2 13.6229 7.70102 9.77244 -0.136865 10.7899 -7.02632 +363 2 12.7945 7.93077 10.9815 -6.52785 3.68747 11.7154 +364 1 15.1981 8.09018 3.38532 -13.0459 -52.6521 2.11346 +365 2 14.5247 7.61376 2.86907 3.36606 26.685 -8.7616 +366 2 15.3386 7.39586 4.05885 15.5852 26.7124 4.01456 +367 1 17.1365 6.7605 0.0284285 -19.4133 2.32297 -2.08842 +368 2 16.6422 5.96523 0.300426 11.1165 9.80228 -2.81184 +369 2 16.4267 7.37993 18.3943 16.5678 -7.00446 5.84521 +370 1 8.97527 7.00353 7.90402 -12.8517 -1.3564 7.9131 +371 2 9.8962 7.25242 7.83012 8.98921 2.98997 4.36252 +372 2 8.82463 6.62979 8.79874 5.5237 0.780274 -18.1173 +373 1 12.5342 0.599732 1.22272 7.37234 -11.2249 5.10795 +374 2 13.3221 0.863275 1.71742 -3.27048 6.46822 -3.34517 +375 2 12.885 0.18837 0.429335 -4.8121 3.35952 -2.50919 +376 1 5.70486 15.0289 14.4325 -10.0966 26.0987 -8.04315 +377 2 4.75654 15.1126 14.6498 8.83064 -2.51751 -1.0487 +378 2 5.99172 15.9344 14.1552 -2.67099 -19.6319 8.34541 +379 1 3.68772 6.51886 1.67786 -9.02664 17.532 -4.1283 +380 2 3.3123 7.35563 1.32777 6.95322 -18.4916 -0.718273 +381 2 3.69933 6.70385 2.62114 4.49099 -5.2411 1.79351 +382 1 3.84119 11.2683 12.301 -11.0219 1.87445 3.30422 +383 2 4.7083 11.6207 12.5295 0.62865 1.71432 1.43021 +384 2 3.16952 11.829 12.7259 9.18863 0.324364 -2.3982 +385 1 5.33774 3.90131 15.6575 3.88008 58.1131 -0.302695 +386 2 6.0029 3.30263 15.356 18.6017 -19.7261 -0.90724 +387 2 5.77609 4.81808 15.6348 -20.8077 -39.2998 1.51453 +388 1 13.9476 10.0954 4.76119 43.1598 -13.631 -14.8551 +389 2 14.3099 9.89525 5.64952 -11.5358 -2.78357 -16.2598 +390 2 14.5437 9.62633 4.09138 -26.3956 16.5702 30.5617 +391 1 7.47949 17.2779 8.9575 1.27559 12.2273 10.3752 +392 2 6.80648 17.541 9.63427 13.3482 -0.885269 -20.4433 +393 2 7.81637 18.0666 8.4826 -8.0179 -7.75644 7.92076 +394 1 4.60365 14.3557 3.73459 -2.67085 -0.0597314 40.4087 +395 2 4.53549 15.2621 4.14744 4.43815 -28.6634 -11.7113 +396 2 4.62044 13.6529 4.46513 -1.80956 31.3212 -27.6241 +397 1 14.2431 7.29194 15.9057 25.6353 16.9765 2.1683 +398 2 15.0475 7.32515 15.3368 -17.0197 -3.00413 14.2387 +399 2 14.4656 7.87429 16.6673 -6.53416 -15.6271 -13.0076 +400 1 2.96496 18.4208 1.99119 15.7852 32.1682 20.7835 +401 2 2.67672 17.8955 1.28044 -15.5564 -27.5435 -28.9446 +402 2 2.23493 0.385121 2.17733 5.2916 -3.96739 2.45348 +403 1 7.98476 1.5873 4.50407 1.38949 2.52923 0.695279 +404 2 7.37343 2.0449 3.91068 5.19751 -1.80104 2.00097 +405 2 8.86519 1.9238 4.29038 -5.22298 -3.29695 -0.501883 +406 1 2.57117 14.1691 17.7571 1.007 -17.2424 4.53378 +407 2 1.90219 13.4698 17.9606 14.5878 19.4169 -2.4542 +408 2 3.44824 13.7555 17.8862 -10.6426 1.83574 2.42644 +409 1 1.00451 2.03285 13.8784 10.3502 2.39599 -10.3714 +410 2 1.16144 1.84563 14.7992 2.97823 -2.88805 14.0985 +411 2 0.0700994 1.90667 13.7535 -13.5508 1.82952 -2.05389 +412 1 4.33902 0.200757 13.8843 13.0721 -10.005 -1.30306 +413 2 5.22858 18.4296 13.858 -15.0619 9.43809 1.75921 +414 2 3.93054 18.5168 14.6942 4.28146 4.19272 1.73225 +415 1 7.39543 1.05973 18.4904 -6.66444 -3.84456 4.72925 +416 2 7.66739 0.634389 17.6825 2.48525 -3.87431 -15.5197 +417 2 6.44311 1.20989 18.4324 3.08246 -0.882049 5.31666 +418 1 15.7652 18.4035 13.928 -3.86344 6.1861 11.5309 +419 2 14.8535 18.6979 13.7607 9.26883 -6.83338 6.65234 +420 2 15.8985 -0.310566 14.8997 -7.7909 7.80446 -17.2978 +421 1 10.2952 4.64795 16.1844 -42.7729 -17.7833 -2.18791 +422 2 11.2045 4.84382 16.2798 37.5776 1.06228 1.58962 +423 2 10.2217 3.67206 16.1998 1.46017 15.0252 -2.22652 +424 1 15.8927 17.6472 4.46477 -15.4234 23.5431 17.5975 +425 2 16.4754 18.4255 4.65687 -16.3789 -18.5079 -6.3799 +426 2 14.9773 17.9018 4.78742 33.6258 -6.52099 -13.8394 +427 1 6.90155 17.6195 13.966 46.0362 -18.082 7.69792 +428 2 7.5054 17.5909 14.7751 -24.8486 6.04139 -28.3759 +429 2 7.50943 17.3755 13.214 -16.8133 11.713 21.5591 +430 1 13.2082 6.37265 6.52765 -13.548 -6.29238 7.5029 +431 2 14.0171 6.83631 6.34759 17.8515 4.0742 0.884882 +432 2 12.7912 6.26458 5.66961 -1.80962 -1.49443 -3.94736 +433 1 7.85263 2.26509 9.52735 -7.99894 -5.84405 -22.7054 +434 2 7.25184 2.06178 10.2504 -3.996 2.15095 3.09306 +435 2 7.39499 1.97805 8.69805 10.2818 7.88442 20.3126 +436 1 15.1135 14.8377 13.7906 -14.0873 7.85215 4.54273 +437 2 14.8065 15.1503 14.6696 4.89633 -5.66092 -15.9193 +438 2 14.526 15.2486 13.1323 8.68819 -2.70507 8.56313 +439 1 9.34389 8.42481 3.82801 17.2784 -12.6228 -3.36469 +440 2 10.2481 8.71643 4.0808 -19.781 -0.493733 -4.13474 +441 2 9.39514 7.45876 3.71283 -1.01674 10.6173 4.41109 +442 1 17.6406 13.5721 16.5094 2.04355 14.6677 -13.2606 +443 2 16.6957 13.3564 16.5004 3.03121 5.86868 -4.35941 +444 2 17.7908 14.3862 15.9732 -9.46726 -16.3028 8.56732 +445 1 4.98477 10.3524 2.78056 12.7386 5.36526 19.5004 +446 2 5.77841 9.87677 3.08402 -8.11584 2.70387 -5.95057 +447 2 4.78102 10.9105 3.55814 -3.18863 -4.34789 -14.1468 +448 1 3.61985 8.409 9.90418 -6.90754 6.83907 7.996 +449 2 3.65115 9.35813 9.71914 3.08439 -3.40065 -3.71786 +450 2 3.2182 8.36489 10.7858 3.70965 -2.47637 -5.74153 +451 1 15.9601 6.9243 5.80742 5.84252 7.06727 3.15212 +452 2 16.6786 7.33659 6.3256 -10.6597 -9.43019 -8.8571 +453 2 16.2068 5.99858 5.66915 1.21675 5.97088 2.68601 +454 1 15.2845 7.30815 8.96614 12.789 49.367 -12.5087 +455 2 15.9618 7.62249 9.60336 -10.429 -10.3168 -7.48119 +456 2 15.189 8.09577 8.33246 -3.07462 -40.144 23.8491 +457 1 6.1828 12.7537 12.7561 7.28509 13.2747 4.63662 +458 2 7.05451 12.4627 13.0861 -13.4204 -0.208789 -0.140696 +459 2 5.95622 13.5898 13.2147 8.13015 -13.1574 -2.88232 +460 1 12.1263 4.55994 13.1396 29.7192 24.8274 2.05513 +461 2 12.1786 4.68706 14.0984 -0.0287765 -3.56256 -2.83377 +462 2 11.367 4.05454 12.9285 -29.3831 -17.3036 -0.987503 +463 1 11.4694 8.07241 7.80966 2.82892 -5.30182 3.11258 +464 2 12.1089 7.42736 7.43222 -7.16455 14.3649 9.80055 +465 2 11.7078 8.26067 8.74179 3.19872 -8.99269 -16.594 +466 1 16.9463 10.7531 7.60486 21.0922 -19.3927 -30.7185 +467 2 17.5464 10.0071 7.31859 -16.0594 21.8542 15.0855 +468 2 16.9098 11.3402 6.82058 -3.06841 -4.58473 14.7168 +469 1 5.28146 18.0409 10.6472 -25.9515 -7.83546 -6.26387 +470 2 4.85268 17.2439 11.0337 11.609 18.382 -10.1496 +471 2 4.62194 18.3715 9.98111 20.3861 -11.8767 18.8687 +472 1 7.65293 17.466 1.56177 -3.43219 -2.17163 16.4468 +473 2 8.27069 16.8213 1.23778 3.23069 -17.6415 -5.16563 +474 2 7.58305 18.0963 0.859771 -3.72786 20.9018 -9.77855 +475 1 1.92587 12.9087 13.6164 -8.16731 5.11551 18.4441 +476 2 1.30634 12.3949 14.1755 13.4846 7.44573 -7.00244 +477 2 2.13079 13.7319 14.1159 -1.95883 -16.9131 -9.84331 +478 1 9.29336 6.75339 14.7687 -19.1125 21.7104 1.76678 +479 2 9.711 5.9819 15.1082 15.9481 -24.452 8.13362 +480 2 9.58853 6.88119 13.8676 2.75751 0.822828 -8.36077 +481 1 15.2452 4.28737 10.7623 -0.225576 -4.08648 -1.74219 +482 2 16.1503 3.99339 10.8719 6.1947 -5.72264 -8.71474 +483 2 15.1717 4.92602 11.4736 -7.0877 3.5816 0.665059 +484 1 11.4391 6.24473 0.0517087 -15.4849 -28.4826 -7.88372 +485 2 11.5335 5.29025 18.4586 5.11122 21.8085 5.83846 +486 2 10.469 6.36117 18.7264 13.3105 4.99187 -1.92993 +487 1 18.4571 11.4845 14.9094 -8.14212 27.2991 -26.8701 +488 2 18.0442 12.0056 14.1458 10.7134 -26.1217 30.6713 +489 2 18.3691 12.0954 15.6567 -1.55188 -2.54901 -1.51407 +490 1 7.07006 9.2713 7.35429 3.52198 -23.4346 -4.90088 +491 2 6.57918 8.46088 7.59869 6.01934 15.522 -0.341791 +492 2 7.98054 8.95273 7.2441 -4.91945 6.78887 2.19469 +493 1 18.4213 15.3485 12.1512 14.6289 14.7183 -5.00343 +494 2 0.703338 15.6554 12.0361 -12.928 -5.55139 4.18882 +495 2 17.8805 15.9633 11.6295 -1.60931 -6.92771 2.64168 +496 1 16.5853 4.3259 5.32941 -3.23822 -14.2219 46.7572 +497 2 16.614 4.15863 6.32722 1.43031 7.89007 -40.0485 +498 2 17.5031 4.43236 5.0545 -4.12857 4.88068 -4.00684 +499 1 17.7656 3.15988 10.7489 -7.77815 -3.54726 5.22618 +500 2 18.6517 3.33727 11.1036 -6.02481 -6.41431 -8.69585 +501 2 17.7347 2.25304 10.4054 5.10772 5.83768 0.491016 +502 1 12.3532 18.6195 10.0845 2.26138 29.9542 0.82462 +503 2 11.4554 0.369133 10.2956 34.814 -7.7062 -6.49387 +504 2 13.0539 0.703372 10.1287 -31.4455 -25.8056 2.12568 +505 1 10.4062 9.7592 12.5463 4.94309 9.48659 9.1975 +506 2 11.1178 9.86775 13.2051 -4.84217 -3.21907 -8.75193 +507 2 10.4169 8.83 12.3092 -0.242296 -5.43122 1.67162 +508 1 0.754807 2.57366 7.2759 5.10959 9.37805 -1.17349 +509 2 1.15147 3.40426 7.59563 -2.53061 -11.14 3.70439 +510 2 0.94825 1.90755 7.95351 -0.370046 8.4477 -4.76995 +511 1 0.326852 15.3245 6.92393 7.78779 -47.7914 -15.9381 +512 2 0.478367 15.1955 7.87742 -3.54148 6.5065 -12.4551 +513 2 0.511792 14.4078 6.50445 -6.22026 47.2618 21.2659 +514 1 17.0448 6.87527 14.9011 7.50868 -3.64469 2.18783 +515 2 17.7829 7.50382 14.839 -4.82102 -5.02166 1.59119 +516 2 17.384 6.09018 15.3732 -3.19441 8.7454 -5.86774 +517 1 9.10521 12.4991 8.01627 -22.444 -7.37457 -9.07321 +518 2 9.5155 11.7197 7.59468 -6.97176 5.64777 -5.01838 +519 2 8.17012 12.5725 7.67989 31.3303 -7.17656 9.91942 +520 1 1.12679 1.65794 2.79756 -4.95635 8.46302 6.6874 +521 2 0.642552 2.15227 2.11219 8.6081 -1.07022 6.53976 +522 2 1.60228 2.28223 3.37541 -5.16033 -3.32404 -9.46208 +523 1 4.24509 15.0269 10.0531 -9.28044 4.63084 -2.70058 +524 2 3.93721 15.2031 9.15401 2.26907 2.00751 2.33164 +525 2 5.07496 14.5648 9.92961 6.13338 0.348707 3.17177 +526 1 7.39613 2.22212 14.8791 -10.1428 -2.73186 -2.62368 +527 2 7.12857 1.59843 14.1951 -0.211704 -1.85534 3.14611 +528 2 7.6308 3.01777 14.3992 6.19568 3.75469 -5.36272 +529 1 18.3005 14.5161 2.14907 5.30067 -9.26209 1.4902 +530 2 0.506128 14.8057 2.49377 4.6744 -0.083839 -4.04908 +531 2 17.8019 15.308 1.97101 -9.85855 11.1774 -0.48774 +532 1 10.0782 2.71092 12.8944 3.88974 -3.73664 -2.78909 +533 2 9.88925 2.05355 12.2072 4.3936 3.86452 2.74403 +534 2 9.31937 3.3006 12.9074 -3.94823 0.261307 -1.05017 +535 1 2.9306 8.79131 12.9512 -25.6961 -20.8645 -0.44372 +536 2 3.33593 9.62792 12.788 10.417 21.0465 -4.83397 +537 2 3.64632 8.1716 13.058 11.1871 -7.80414 6.67576 +538 1 3.17851 8.59155 3.78391 36.0219 9.48042 20.5594 +539 2 3.64638 9.17092 3.16182 -4.0064 -4.18597 2.27442 +540 2 3.67104 8.74964 4.63715 -24.9674 -6.25544 -24.3579 +541 1 5.79667 7.27872 8.61723 -5.158 -8.45889 2.36629 +542 2 5.76122 6.32524 8.453 -1.10357 3.40671 2.32671 +543 2 5.00318 7.4879 9.12925 4.38374 0.567505 0.838777 +544 1 14.9116 1.65307 1.84567 7.03031 -5.18946 -10.6018 +545 2 15.1062 2.45757 2.3139 -4.94852 6.93451 15.0643 +546 2 15.1691 1.84916 0.935056 -0.310542 -6.30296 3.0909 +547 1 8.67523 15.0369 0.613894 1.37845 1.1536 3.61737 +548 2 9.43682 15.0729 1.21213 -3.42809 -6.51916 3.89646 +549 2 8.00447 14.4711 1.03609 4.49017 7.63347 -1.72767 +550 1 15.3993 1.47022 7.19229 -20.8703 -2.58026 0.276614 +551 2 14.6837 0.967989 6.72584 19.4319 15.0033 11.4079 +552 2 14.9834 2.26826 7.5843 2.60239 -12.333 -11.18 +553 1 4.89704 12.855 18.4725 17.7474 3.66438 12.0852 +554 2 5.22521 13.0209 0.739851 -5.30909 -3.44768 -15.7686 +555 2 5.64886 13.1114 17.9131 -8.88833 1.88365 4.35483 +556 1 15.3966 8.71526 18.0579 -0.0737912 10.217 -6.92241 +557 2 15.7913 9.20885 17.3059 -4.72516 -6.1114 19.2356 +558 2 15.2466 9.35419 0.13361 -0.210218 -4.05252 -7.18588 +559 1 11.9654 3.16879 18.3684 -1.96391 -6.33771 9.57431 +560 2 11.8782 2.93896 0.667559 5.83177 -2.01678 -11.7343 +561 2 12.3624 2.38725 17.9444 -0.743858 8.0566 3.61175 +562 1 13.1976 12.733 5.19814 3.21154 2.81721 -3.88454 +563 2 13.6265 11.8743 5.11099 -2.80289 -1.59076 -2.45209 +564 2 13.3962 13.0406 6.08845 -1.48061 -3.43823 1.63358 +565 1 6.20234 7.07161 0.291392 8.37087 -8.50913 -15.2358 +566 2 6.21431 8.03007 18.9132 -3.08565 9.14852 3.50692 +567 2 5.28911 6.79756 0.384068 -8.05152 4.04277 7.5169 +568 1 17.755 15.8811 14.8809 -0.846783 4.67036 -1.95176 +569 2 16.8205 16.1356 14.922 6.46156 -5.25763 -8.70949 +570 2 17.9775 15.7319 13.9423 -7.01069 1.37948 9.8425 +571 1 13.0816 0.927432 16.7559 7.19813 -13.1533 1.9849 +572 2 14.0246 0.654652 16.7787 -14.5584 8.9122 1.46691 +573 2 12.5958 0.0867106 16.6751 4.09548 8.26383 -2.86333 +574 1 10.8721 14.5032 7.42074 17.8947 27.9436 -17.0444 +575 2 10.196 13.9242 7.71676 -22.829 -18.2345 11.9548 +576 2 11.6972 14.0514 7.58445 7.42519 -9.80791 -0.577526 +577 1 17.7647 8.42346 2.16939 -4.1598 1.60766 -5.89387 +578 2 16.8709 8.3975 2.49669 -12.234 5.23478 11.868 +579 2 17.7295 7.75318 1.48744 5.54579 -3.65645 -10.0136 +580 1 12.5773 7.79072 2.0332 1.0668 2.49746 -6.2566 +581 2 12.3914 8.73063 1.87761 -0.101344 -7.79782 -0.82295 +582 2 12.2276 7.2965 1.27263 1.31444 5.98607 5.5368 +583 1 12.0208 14.4615 10.4933 -27.7219 6.00234 -17.9899 +584 2 12.3406 14.2687 9.58404 -10.0812 4.98999 20.4987 +585 2 11.0483 14.7039 10.4238 33.6221 -8.97773 -1.58279 +586 1 6.69486 6.68845 15.5484 18.1135 9.98152 11.3143 +587 2 7.65688 6.85274 15.3559 -27.8703 -4.06425 5.81014 +588 2 6.48582 7.17335 16.3722 6.10572 -10.2019 -13.6564 +589 1 7.96659 4.39718 13.2272 4.51058 -7.9075 4.77481 +590 2 7.2893 4.70584 12.6248 -6.54048 3.46732 -4.14994 +591 2 8.21018 5.15068 13.7582 2.30488 10.1178 3.17748 +592 1 13.2671 12.2369 14.4347 -4.64765 -4.51239 1.04229 +593 2 13.0608 11.2949 14.304 4.07546 7.63325 0.952283 +594 2 13.624 12.5445 13.5893 -0.484314 -1.81518 4.66288 +595 1 14.4631 9.64208 7.37348 -3.22195 -17.9745 -8.46037 +596 2 15.2455 10.1455 7.54143 19.6931 12.3162 5.07411 +597 2 13.7594 10.075 7.84063 -11.2512 5.66435 9.63044 +598 1 12.6955 16.8004 3.38503 4.61351 40.5798 -15.2407 +599 2 12.79 17.4151 4.16128 -2.51333 -18.5745 -25.4999 +600 2 12.6728 17.373 2.55111 0.0132769 -17.6878 38.2975 +601 1 0.968812 6.96727 17.3326 -17.527 29.8281 -14.7856 +602 2 0.0966102 7.11435 17.7475 9.38145 -12.9539 -1.45746 +603 2 0.942675 7.56475 16.5473 6.51552 -11.7527 16.88 +604 1 12.9918 4.86088 15.7598 14.9884 1.53364 0.213735 +605 2 13.6417 4.12341 15.6561 -13.2544 27.5281 4.62454 +606 2 13.5036 5.69571 15.8607 -8.5455 -17.4296 -3.38108 +607 1 2.31456 3.41181 5.02375 -16.8072 14.5355 28.5245 +608 2 1.72499 3.01856 5.74541 26.0591 16.5367 -23.5498 +609 2 2.61813 4.33638 5.31016 -13.7452 -42.3935 -5.38282 +610 1 8.12877 10.8743 13.7813 26.8177 -26.1009 35.9685 +611 2 8.08888 10.4248 14.7095 5.12746 27.8083 -58.2879 +612 2 8.93477 10.511 13.3312 -19.2021 7.65314 13.0743 +613 1 13.0038 1.57226 13.2324 0.46489 2.31008 -10.6366 +614 2 13.6096 1.43937 12.4592 -18.9356 10.6634 16.2552 +615 2 12.412 2.34128 13.062 19.3329 -16.3736 -0.813643 +616 1 6.65189 13.7072 1.97939 -2.77776 -1.20266 13.9341 +617 2 6.01392 14.2112 2.53362 13.0928 -13.1372 -7.18637 +618 2 7.15166 13.1216 2.589 -8.8324 11.1791 -7.86511 +619 1 15.7768 6.33135 12.4394 -16.9523 -8.61752 -2.39927 +620 2 16.2545 6.83373 11.7966 11.5481 11.8457 -13.8092 +621 2 16.2346 6.49819 13.2509 8.584 1.06891 20.063 +622 1 16.7487 0.656157 9.53186 -1.89022 -32.3669 -10.6998 +623 2 16.6929 18.3191 9.69193 -1.14735 24.5709 0.588436 +624 2 16.3744 0.798362 8.64008 0.39513 1.76057 8.35052 +625 1 6.2256 11.6996 8.23382 -7.45249 -33.5883 4.29961 +626 2 5.41287 11.5766 8.79278 22.02 -5.73867 -21.2662 +627 2 6.53136 10.7979 7.88958 -15.1732 37.063 20.6987 +628 1 2.75779 8.608 0.340468 -48.3199 -4.33351 -7.97969 +629 2 2.08546 8.0585 18.4464 30.1073 27.602 24.3697 +630 2 2.23564 9.25518 0.892435 12.8354 -18.7139 -20.5564 +631 1 10.0773 10.2182 6.62419 2.67327 1.92209 4.62159 +632 2 10.5668 9.53044 7.10449 -1.07652 4.95909 -5.68289 +633 2 10.5655 10.3766 5.79827 -6.62323 -4.53969 7.46345 +634 1 6.84859 15.7294 6.8116 4.5172 -4.61086 -5.81045 +635 2 7.14728 16.2498 7.57791 -4.63192 -2.64256 -11.095 +636 2 7.17659 16.1616 6.00258 -4.95191 3.23702 9.76552 +637 1 6.62071 12.9207 5.93401 2.33655 2.8557 1.84805 +638 2 6.83452 13.8255 6.17261 -0.629609 6.79635 0.913528 +639 2 6.25462 12.5309 6.73716 -1.14115 0.401949 -5.14594 +640 1 16.7089 12.5339 9.77339 -0.869689 -1.39856 -8.71911 +641 2 16.7622 11.7819 9.15626 3.31473 10.0385 4.47785 +642 2 17.1611 13.2788 9.34464 -3.7572 -10.2702 6.17681 +643 1 6.29845 2.79213 2.75928 -3.20566 -14.4941 8.67087 +644 2 6.41489 3.68807 2.47435 5.42045 18.7619 -3.24562 +645 2 5.94058 2.32523 2.00482 -4.41542 -3.11109 -6.82659 +646 1 10.6289 2.95834 3.25769 -6.57134 8.8614 -3.08687 +647 2 10.3824 3.87829 3.42309 -0.834706 -5.50201 2.33367 +648 2 10.1446 2.71475 2.45701 2.51779 -3.35726 0.152255 diff --git a/examples/amoeba/dump.water_box.hippo.32 b/examples/amoeba/dump.water_box.hippo.32 new file mode 100644 index 0000000000..33463a3a5d --- /dev/null +++ b/examples/amoeba/dump.water_box.hippo.32 @@ -0,0 +1,7227 @@ +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.67966 7.08769 17.9461 -19.3527 -13.639 6.25201 +2 2 7.80945 6.75579 18.2607 18.4949 11.1596 -6.01922 +3 2 8.72223 6.81424 17.0254 5.85599 -0.890166 3.45586 +4 1 18.5257 8.24445 6.83762 11.8085 12.5587 58.8481 +5 2 0.216892 7.89544 6.05003 10.8935 -14.9684 -50.5046 +6 2 0.444268 7.82601 7.5302 -15.2958 7.9793 -8.89884 +7 1 8.37906 18.5504 6.81463 25.5385 6.64228 -3.75624 +8 2 9.34042 0.098069 6.73406 -20.9151 -2.68951 1.38711 +9 2 7.93962 0.573676 6.26984 -0.656308 -0.308718 3.40946 +10 1 6.58995 1.84432 11.7198 46.6828 -15.9611 -12.5859 +11 2 5.88543 2.40231 11.9251 -37.6261 28.8114 18.1934 +12 2 6.18153 1.06275 11.3693 -6.58868 -16.6156 -5.55691 +13 1 7.1466 5.75358 2.33152 -56.1364 42.5085 -2.61462 +14 2 6.36812 6.12603 2.86268 40.1937 -23.4301 -4.21826 +15 2 7.02502 6.29465 1.5182 16.3021 -20.7884 10.9258 +16 1 16.2164 10.1388 16.1382 -32.0875 21.5958 16.7579 +17 2 16.9509 10.2747 15.5847 32.9015 -1.03241 -20.1636 +18 2 15.8498 11.0405 16.2399 1.98783 -14.756 2.71439 +19 1 10.6046 15.0374 2.30369 -8.13409 -25.494 -7.18668 +20 2 10.5292 14.3949 3.01849 1.41683 -0.603724 2.75561 +21 2 11.0236 15.78 2.70962 11.6057 19.8833 4.5888 +22 1 17.1624 8.24409 10.3708 13.0676 7.07862 9.73504 +23 2 16.5528 8.68798 10.966 -4.65968 7.37974 1.83434 +24 2 17.9421 8.82333 10.3208 -6.34155 -10.1937 -2.20396 +25 1 14.901 15.8652 16.3167 18.01 -6.87509 18.5636 +26 2 14.0225 16.1982 16.2525 -26.9236 12.7201 -6.50875 +27 2 14.9141 15.482 17.2099 2.63751 -6.05913 -7.59706 +28 1 12.1752 13.3771 0.408263 -11.3168 6.26442 9.98381 +29 2 12.0579 13.8465 18.23 5.67057 -4.50268 -16.0578 +30 2 11.6217 13.8904 1.00796 3.42507 -1.00312 9.73088 +31 1 9.27358 5.34243 4.05546 -35.2781 32.5984 16.8393 +32 2 8.64594 5.4665 4.83764 28.3783 -16.8163 -28.778 +33 2 8.74177 5.68615 3.30282 7.52493 -14.9247 9.48156 +34 1 1.83016 4.27673 11.6495 -21.1764 37.5598 -8.14901 +35 2 1.70328 5.22377 11.9391 6.02814 -28.7768 -8.29565 +36 2 2.40811 3.85345 12.2597 13.4728 -11.3181 18.3421 +37 1 1.96438 6.83299 8.3731 -11.1902 3.43717 -25.3738 +38 2 2.49614 7.21578 9.0563 9.35281 -0.190165 18.6039 +39 2 1.81128 5.90585 8.57354 7.84101 -3.79534 5.21373 +40 1 5.40557 4.38899 7.93274 -6.81526 4.7224 -2.63907 +41 2 5.53738 3.43895 7.78131 -7.79962 9.88898 0.533881 +42 2 4.75516 4.73491 7.29062 10.7858 -16.238 7.24535 +43 1 3.23 2.92842 17.5524 -0.538114 20.9936 16.7312 +44 2 3.93109 3.19827 16.9402 -0.965509 8.21721 4.01649 +45 2 3.00444 3.70897 18.1497 6.13449 -29.114 -23.6081 +46 1 7.4624 5.26283 6.13117 9.12728 4.25284 -1.73168 +47 2 8.02565 5.58849 6.88177 -24.817 -14.4341 -14.6054 +48 2 6.93508 4.45577 6.3254 16.0496 22.0303 12.0173 +49 1 9.77896 7.02384 11.9834 11.1205 -3.87253 23.9446 +50 2 10.2721 6.37256 11.5011 10.9222 -10.0302 -1.39678 +51 2 9.1532 7.31587 11.3499 -23.6433 13.1239 -20.7784 +52 1 14.1167 3.54999 8.03003 -30.7601 -1.60704 -37.9113 +53 2 13.4732 4.22413 7.73132 15.1608 -10.723 4.30178 +54 2 14.3809 3.80189 8.88487 12.8065 16.1495 34.678 +55 1 4.82329 17.2568 4.03846 -17.85 32.0436 -31.4073 +56 2 5.49315 17.973 4.01308 -7.71314 -24.6342 10.4391 +57 2 4.18746 17.5412 3.33843 10.9703 -13.5421 12.8553 +58 1 16.4918 16.6259 10.0493 29.9016 15.3745 -40.7533 +59 2 16.1673 16.3226 10.8594 -24.6786 -13.0437 37.8908 +60 2 15.9925 16.2084 9.33562 -4.01544 -1.82242 7.63759 +61 1 1.94489 4.93323 0.49791 29.1886 10.4759 3.59715 +62 2 2.55322 5.26335 1.2053 -17.2324 -10.4098 -15.9422 +63 2 2.08253 5.591 18.4408 -14.7087 -3.80383 3.81857 +64 1 11.816 13.3571 16.2711 -7.8083 1.12937 6.2001 +65 2 11.2371 12.6203 16.5671 13.3708 1.96491 -16.2063 +66 2 12.2446 13.1893 15.4079 -11.197 -7.32732 11.8633 +67 1 10.105 11.0651 16.9545 16.7158 -32.7784 1.37979 +68 2 10.5674 10.1947 17.1295 -14.0823 30.097 -5.45833 +69 2 9.25349 10.8067 16.5912 -2.99511 2.11526 2.57572 +70 1 11.7264 17.5421 13.4742 2.50122 -25.0158 -11.214 +71 2 12.2771 16.9836 12.8968 -8.91486 0.79877 6.23222 +72 2 12.1041 18.3936 13.317 1.59091 22.4782 2.42571 +73 1 6.33029 9.31911 12.2264 15.6898 -25.4439 -25.1534 +74 2 7.02603 8.96242 11.6353 -17.823 2.07037 1.33758 +75 2 6.81249 9.95941 12.7172 5.93051 22.1649 19.4162 +76 1 16.2187 12.7249 2.70186 -8.69715 -37.3569 7.82337 +77 2 17.0292 13.1566 2.50302 19.6243 18.7999 -9.68795 +78 2 15.4982 13.3357 2.61812 -8.61102 21.6356 1.57727 +79 1 0.637202 12.5625 5.84914 -32.6687 7.10288 -2.13707 +80 2 0.892312 12.5507 4.90771 -4.51242 -1.40786 13.4578 +81 2 18.3039 12.804 5.85329 37.5994 -4.88925 -6.97833 +82 1 5.19922 16.3781 18.5047 -7.71264 -0.634541 -12.9921 +83 2 5.80284 15.8543 17.9455 2.11468 10.7978 13.7187 +84 2 5.67034 16.9636 0.462296 7.23142 -5.58048 -3.24093 +85 1 0.510145 7.62945 4.0545 45.851 19.5686 -25.4796 +86 2 18.5719 8.14656 3.45296 9.61971 -16.7838 10.3831 +87 2 1.46496 7.74082 3.66917 -52.3954 -1.94356 25.3273 +88 1 3.14672 8.89584 6.52626 -54.2957 5.34018 -1.73828 +89 2 3.50609 8.59991 7.35294 9.18701 -2.26398 8.55435 +90 2 2.14573 8.92962 6.68203 45.3688 -0.563656 -9.64228 +91 1 7.30854 10.3037 16.1717 -0.0267506 0.140778 15.7468 +92 2 6.56213 10.4624 15.5802 1.32412 -0.384411 10.7132 +93 2 6.99303 10.278 17.1118 0.130505 3.94788 -23.0495 +94 1 11.1122 1.06968 4.98939 -2.83136 -16.8604 13.0177 +95 2 11.0776 1.97142 4.64864 2.2702 -4.31387 -11.6367 +96 2 10.7048 0.433547 4.37027 2.96408 14.9419 -2.56144 +97 1 4.45204 2.70061 13.2052 -8.32298 -31.9478 35.5434 +98 2 4.60333 3.05865 14.0914 -0.476624 15.5497 -15.2927 +99 2 4.38645 1.737 13.4626 0.207127 24.1129 -25.2696 +100 1 8.42792 10.0237 1.78469 -10.6267 -17.9408 16.848 +101 2 8.3405 10.6377 2.53622 4.43246 -2.98222 -4.40025 +102 2 8.49672 9.11244 2.17467 4.60711 29.3182 -9.45134 +103 1 10.5335 1.75383 15.546 -31.9958 -1.22726 0.532554 +104 2 11.3977 1.82718 15.9216 23.4057 -5.242 -0.0927752 +105 2 10.5608 1.78317 14.5837 3.34522 3.38855 0.282019 +106 1 2.77693 12.941 7.74821 -10.6415 2.34425 -2.27994 +107 2 3.28797 13.5733 7.23382 5.58977 0.334345 4.09149 +108 2 1.98704 12.8256 7.20013 5.22386 -8.52712 2.54059 +109 1 3.63517 11.6895 5.33963 -10.2259 -13.0028 -10.3717 +110 2 3.35385 11.0502 6.03137 4.73753 15.317 -16.6328 +111 2 2.8758 11.855 4.74058 11.3048 -4.09559 12.5928 +112 1 6.88803 14.474 16.8428 -13.42 9.46677 6.94107 +113 2 7.55973 13.8293 16.6383 4.5229 -1.76969 -1.40507 +114 2 6.60381 14.8838 16.0165 0.0834179 -9.06129 -0.120708 +115 1 14.1722 14.5374 3.41536 20.1951 -3.19134 -21.8839 +116 2 13.6514 15.2845 3.14096 -9.23852 13.3738 0.77613 +117 2 13.8512 14.2508 4.25439 -13.5451 -9.47926 16.7085 +118 1 8.28226 18.1809 16.0824 -9.43856 -15.6135 -5.07226 +119 2 8.77677 17.3494 16.3071 1.43839 31.5077 -5.33478 +120 2 8.7603 0.384816 15.9919 11.1327 -19.5096 4.24776 +121 1 4.73724 1.61643 4.90111 5.86874 37.6921 -30.6753 +122 2 3.96969 2.16837 5.15263 9.12039 -10.9712 -6.28456 +123 2 5.18465 2.1484 4.15475 -17.6049 -26.8232 41.7187 +124 1 15.1457 12.8616 16.4403 -17.0638 -11.2899 43.408 +125 2 14.6041 12.8692 17.2613 22.7365 8.03356 -12.6578 +126 2 14.49 12.6307 15.8136 -17.0236 -4.89604 -35.7974 +127 1 15.779 18.3837 16.786 48.5063 8.0766 44.3104 +128 2 16.5108 18.615 17.4688 -41.9285 -7.99937 -34.0327 +129 2 15.7694 17.4186 16.7687 -10.3466 2.2793 -1.1406 +130 1 1.1383 1.1331 16.5571 -3.54071 10.9478 5.94974 +131 2 1.96551 1.50352 16.9177 -15.9767 0.55296 -3.51275 +132 2 0.420521 1.53444 17.0916 21.5279 -7.8795 -5.43288 +133 1 18.0817 4.5907 15.863 15.8138 -19.1991 -2.64562 +134 2 18.5818 3.91936 15.3489 -11.6552 16.5822 9.8521 +135 2 18.5602 4.7339 16.6874 -1.16116 -1.56098 -3.02727 +136 1 12.22 16.9378 16.1148 -9.97587 -12.4224 57.0196 +137 2 11.409 16.6934 16.6676 29.0172 6.05041 -31.7989 +138 2 11.9646 17.3216 15.2917 -14.4882 2.9648 -22.1743 +139 1 15.8709 2.55221 17.9707 -3.56258 26.452 -16.7944 +140 2 15.7355 3.48355 18.2574 6.35046 -25.5765 3.86241 +141 2 15.6659 2.59235 17.0072 6.0189 -6.56803 19.8103 +142 1 6.70868 13.791 10.2637 1.94011 22.9489 3.02058 +143 2 6.59347 13.548 11.1958 0.710608 -4.45224 -7.92394 +144 2 6.58252 13.0514 9.6765 -3.73143 -16.591 0.344408 +145 1 10.146 18.2027 2.80372 16.894 35.9 -12.6825 +146 2 10.2207 0.331961 2.18345 -1.03174 -23.6422 14.9845 +147 2 9.26571 17.8868 2.67703 -18.7462 -7.34721 -7.1199 +148 1 2.97538 17.748 6.06078 -27.2244 1.77787 1.96995 +149 2 2.09399 17.6473 5.67013 1.23544 -3.46851 16.5241 +150 2 3.45883 17.8838 5.26396 32.1509 0.10025 -8.47089 +151 1 12.558 17.0134 7.97028 2.72879 -14.1128 -3.91884 +152 2 11.9572 16.2512 7.82085 4.20569 13.3061 15.6125 +153 2 12.4657 17.4524 8.83591 -10.4039 -6.95813 -9.08653 +154 1 14.8795 15.2862 8.28544 5.56082 -19.5077 38.9848 +155 2 13.9824 15.6136 8.40666 -1.04882 8.68143 -14.5015 +156 2 15.2312 15.4641 7.43118 2.2507 10.8701 -29.8329 +157 1 17.5429 18.3228 0.375372 -51.3852 -2.4253 -14.1847 +158 2 18.116 17.6308 0.128652 38.5367 -21.5025 -8.63787 +159 2 17.9698 0.288559 0.934677 24.3068 21.4661 19.9837 +160 1 0.910209 10.3712 1.41143 -2.71779 -52.992 43.3073 +161 2 0.158544 9.88347 1.87089 22.0109 19.7614 -26.7074 +162 2 0.565924 11.0969 0.944383 -22.7833 34.6337 -23.5778 +163 1 1.55407 12.175 3.31087 16.6578 22.9783 50.8488 +164 2 1.36245 11.4802 2.72234 -7.70692 -21.3552 -33.2695 +165 2 1.61623 13.0206 2.87285 -0.913798 3.83337 -14.7861 +166 1 0.543127 17.2543 4.88609 29.8094 34.6465 -52.7559 +167 2 0.11032 17.9772 5.31124 -19.8915 12.2203 12.8491 +168 2 0.420366 16.4266 5.2673 -10.0988 -43.8479 36.8786 +169 1 1.10053 1.01949 9.38768 20.7334 -4.84081 3.89797 +170 2 1.46081 0.575286 10.1589 7.03147 5.77442 11.7732 +171 2 0.265613 0.594128 9.34525 -29.6063 -3.3853 -10.3011 +172 1 16.8007 2.32783 13.2877 6.1037 15.2386 -31.0559 +173 2 17.0701 2.57314 12.3549 -10.0746 -10.076 30.4228 +174 2 16.4263 1.43993 13.282 1.60122 -3.62923 0.222317 +175 1 2.45231 15.8283 12.1942 27.8718 -10.8871 18.2649 +176 2 2.8623 15.5513 13.0537 -9.1784 7.03247 -27.4702 +177 2 2.91392 15.3801 11.4615 -3.34054 6.42182 7.24567 +178 1 16.435 15.531 5.9458 21.7194 38.3058 -21.2998 +179 2 17.3808 15.5177 6.20547 -16.0791 -6.59953 3.69269 +180 2 16.4147 16.2211 5.22063 -10.9707 -19.0563 26.084 +181 1 5.84547 5.02056 11.8065 15.5941 -20.7973 -13.2046 +182 2 5.55799 5.91374 11.8891 -11.5246 18.633 11.9833 +183 2 5.09 4.45915 11.9819 -3.94875 -1.81326 3.16792 +184 1 15.2214 4.86555 0.731755 -13.7826 -16.8748 28.0949 +185 2 14.6776 4.45845 1.47821 23.1081 18.7106 -26.9415 +186 2 14.6696 4.95834 18.5986 -11.4435 4.17379 2.92627 +187 1 16.3401 16.2933 2.11217 18.5695 -12.4905 -31.3072 +188 2 16.0666 16.7695 2.87319 -12.4192 21.1701 22.1863 +189 2 16.7601 16.9279 1.50378 -10.9162 -1.12869 10.7347 +190 1 0.305885 4.87877 3.79118 -7.51195 53.5881 20.4451 +191 2 0.299338 5.85541 4.09758 -3.10789 -46.5114 -24.0825 +192 2 1.16991 4.5635 4.03062 6.84312 -11.1831 1.05233 +193 1 2.92501 14.9782 15.0356 -4.41813 7.08234 41.1019 +194 2 3.0159 14.7264 15.9987 0.986861 -4.57119 -32.7424 +195 2 2.35392 15.7535 15.1247 6.41577 5.11218 -9.25191 +196 1 1.1115 14.5727 9.55731 53.3594 20.601 -11.7192 +197 2 2.08491 14.4157 9.46275 -24.0912 20.2308 -9.17401 +198 2 0.897072 13.7408 9.90248 -29.0631 -35.5955 19.1061 +199 1 13.6501 16.6688 11.5433 6.78983 17.7214 -9.74398 +200 2 13.4697 17.4567 10.9694 -2.9322 -22.903 16.7504 +201 2 13.5721 15.8897 10.9842 -10.359 0.342192 0.0202177 +202 1 4.73098 1.47842 0.720986 -5.29759 -7.25447 0.0447572 +203 2 4.27169 1.98826 0.034225 -5.56193 -3.14325 9.7343 +204 2 4.11741 0.788607 1.06182 6.25861 16.2271 -3.37713 +205 1 1.42158 18.4663 11.9139 -14.0127 27.0043 -17.9914 +206 2 1.21766 0.394331 12.6648 1.7087 -1.58128 0.41261 +207 2 1.94844 17.765 12.2423 13.0376 -22.9613 11.2697 +208 1 11.5498 10.1018 4.11619 27.4262 20.5676 -21.0421 +209 2 11.5687 10.5955 3.24216 -3.20948 -18.7647 28.9446 +210 2 12.4899 10.1059 4.45555 -29.515 -1.53007 -14.7279 +211 1 8.38254 12.182 3.76573 -26.3924 1.04105 6.81072 +212 2 9.25863 12.501 4.06076 -19.5654 3.48754 6.33549 +213 2 7.63736 12.4251 4.40785 41.4561 -5.4387 -17.0092 +214 1 14.3228 4.03714 3.29709 11.5996 0.889358 18.0886 +215 2 14.8928 4.14179 4.10547 -12.6664 -0.432988 -23.901 +216 2 13.4701 4.45558 3.48891 5.46089 -2.24129 3.2962 +217 1 5.58188 1.78199 7.50513 -33.666 -46.5708 42.0626 +218 2 5.0172 1.13958 8.12095 34.1345 40.5367 -42.64 +219 2 5.33078 1.59122 6.59529 1.4651 -1.13721 -3.53311 +220 1 17.9086 1.12503 4.88467 5.13037 -2.27617 -10.7476 +221 2 18.4038 1.54032 4.14207 -7.55128 -2.38968 19.1857 +222 2 17.6814 1.78344 5.55455 5.62983 -0.00428508 -6.93418 +223 1 6.83101 9.39303 4.49716 -12.9019 3.06885 -29.4929 +224 2 6.83675 9.57499 5.42715 5.2276 -1.57178 18.8103 +225 2 7.66807 8.99049 4.24996 8.60683 3.06936 7.19189 +226 1 2.71406 14.9654 1.962 -12.6433 -7.2797 -26.4735 +227 2 3.33343 14.7912 2.66354 11.3685 -5.36414 4.18623 +228 2 3.09502 14.6645 1.10257 -3.50464 10.9487 24.1748 +229 1 17.279 12.8803 13.1283 -18.5839 20.1434 9.0108 +230 2 16.4044 13.2339 13.3283 -9.51346 -21.2442 0.20606 +231 2 17.6948 13.7346 13.0834 29.6252 3.29486 -10.2855 +232 1 15.0196 10.5818 1.38314 -38.8036 -34.5801 -31.952 +233 2 15.5102 11.1963 1.85791 33.5109 39.8843 28.1173 +234 2 14.3351 11.0964 0.933298 4.14202 -6.46403 5.49191 +235 1 5.71789 6.95838 4.52856 4.11089 -29.6335 9.96606 +236 2 5.85266 7.87985 4.34179 3.17266 16.1428 1.23553 +237 2 6.44364 6.70841 5.13514 -12.5329 -0.461157 -7.94794 +238 1 8.12142 8.26262 10.159 -0.855146 6.49391 46.4818 +239 2 8.58519 8.93965 9.66877 4.4396 1.59282 -10.2318 +240 2 7.56021 7.74854 9.59836 -7.32825 -5.6782 -22.3885 +241 1 13.5311 18.2901 5.8079 -14.4364 -13.815 12.5854 +242 2 12.703 0.102298 5.56963 8.23181 2.14052 6.61043 +243 2 13.2939 17.6289 6.50758 2.60691 23.7973 -17.1373 +244 1 0.327324 2.56344 0.113251 2.62118 15.3541 1.11187 +245 2 18.009 2.52214 18.5736 10.3638 17.1812 4.70476 +246 2 0.724331 3.48299 0.160564 -23.8753 -26.7718 -0.881277 +247 1 12.6396 10.9599 9.76875 -60.0152 14.8867 -10.4701 +248 2 11.6552 10.7306 9.75031 40.0232 26.8927 -4.84212 +249 2 12.944 10.1383 10.0842 28.9404 -31.8014 10.6031 +250 1 0.789377 12.2851 11.08 12.3121 4.77193 16.7259 +251 2 18.4919 12.3017 11.2021 -18.2956 -1.72231 -7.06107 +252 2 1.09088 12.7637 11.8722 5.11265 -11.1183 -7.6011 +253 1 5.04567 7.2193 13.4912 -20.9717 -2.87687 -14.2941 +254 2 5.59899 7.84649 13.0247 8.94565 11.9067 4.64647 +255 2 5.48047 6.97898 14.3058 11.2978 1.34955 6.76892 +256 1 1.28609 6.99027 11.837 -50.3798 -70.0072 -12.7986 +257 2 0.481329 7.14037 11.2978 16.1889 0.462756 10.6855 +258 2 1.71601 7.79102 11.8803 28.8555 60.7949 7.07409 +259 1 15.4442 9.46712 12.3088 17.5488 35.5581 30.8368 +260 2 15.6103 10.4448 12.4444 -11.4156 -32.7422 -13.7105 +261 2 15.5582 9.10301 13.208 -6.0251 -0.167312 -17.6616 +262 1 16.6404 12.9744 5.44078 -0.477448 -16.7093 5.71929 +263 2 16.2955 13.8866 5.54247 6.71099 -18.3284 -17.4666 +264 2 16.51 12.593 4.54035 -5.5475 22.5864 15.6708 +265 1 6.17495 10.0683 0.210584 -22.0037 -7.52033 -29.8636 +266 2 5.35839 10.4511 0.557392 5.20282 -1.85407 -1.83494 +267 2 6.76092 10.0813 0.943985 23.8798 0.550264 15.5383 +268 1 12.3644 6.05734 4.04236 -20.6788 -35.4367 28.6454 +269 2 12.4738 6.70802 3.38308 -3.94744 31.282 -24.9442 +270 2 11.4212 5.77124 4.03221 20.7152 8.11174 -1.23853 +271 1 0.124733 12.8266 0.203961 1.72956 2.54106 -4.3392 +272 2 0.029974 13.5935 0.786871 -3.06107 -4.47794 0.0529132 +273 2 18.185 12.9963 18.0877 7.84157 1.57112 5.96497 +274 1 3.83931 18.5785 8.61972 17.9182 -8.56599 -14.1766 +275 2 3.58625 18.36 7.70531 -6.70328 -0.941099 8.10721 +276 2 3.07994 0.282626 9.06556 -18.5101 7.20519 -0.527908 +277 1 7.37599 17.2741 4.45241 45.8101 34.7343 -2.7797 +278 2 8.02493 17.9603 4.76808 -26.0663 -25.3607 -1.65849 +279 2 7.47725 17.3636 3.49301 -12.8678 -9.31687 6.18264 +280 1 9.20909 17.0315 12.2197 44.1268 -5.71549 17.0535 +281 2 9.48765 16.172 11.8421 -16.3435 15.6721 -2.29993 +282 2 9.99892 17.2887 12.7762 -25.7988 -5.61825 -13.0657 +283 1 13.3284 13.0292 7.94175 -52.6762 -33.6944 -6.73328 +284 2 13.0533 12.253 8.47808 14.3801 9.17086 -2.06391 +285 2 14.1985 13.2855 8.14946 32.3912 12.3835 13.183 +286 1 14.9871 2.94126 15.3478 14.7752 10.8142 -9.8874 +287 2 14.2243 2.52816 14.9303 6.27209 -7.10728 -1.53608 +288 2 15.7054 3.02501 14.6718 -21.9622 -5.02255 13.6584 +289 1 9.85637 15.4939 17.0026 6.25802 5.34328 -5.30261 +290 2 10.2013 14.6312 16.7411 3.93948 4.67059 -1.18803 +291 2 9.35728 15.3668 17.8085 -8.94372 -2.90673 5.88613 +292 1 11.2848 8.23994 16.5492 3.15289 33.2939 2.2253 +293 2 10.8315 7.75123 15.8747 -9.91387 -14.5897 -7.3255 +294 2 11.7506 7.62533 17.1016 4.32393 -13.5731 6.91104 +295 1 3.77097 18.1898 16.7118 5.96936 32.6304 11.943 +296 2 4.24576 17.6768 17.3569 8.77088 -19.0197 5.38959 +297 2 3.7978 0.441972 17.1008 -3.8528 -14.6362 -12.0582 +298 1 2.20581 4.09889 8.95874 4.57905 1.19328 9.26631 +299 2 3.00197 3.55544 8.74643 -17.2537 17.4622 14.7611 +300 2 2.10364 4.24367 9.94001 11.4926 -15.28 -28.3391 +301 1 9.9196 10.3581 9.75231 -27.966 16.15 -17.0738 +302 2 9.34403 11.1055 9.40387 24.0849 -21.7639 18.0289 +303 2 9.87032 10.282 10.7171 1.16507 9.52838 -7.01624 +304 1 9.73405 0.807167 10.8572 18.2139 21.6835 4.91261 +305 2 9.58177 18.5811 11.2204 -14.9491 -12.8069 -2.84973 +306 2 9.10878 1.03014 10.1675 -9.37034 -6.01821 -3.77915 +307 1 9.18221 15.2247 10.2123 -19.1642 -10.2407 -19.6365 +308 2 9.04674 16.0847 9.7631 0.663926 -17.4388 12.4081 +309 2 8.3908 14.6843 9.94105 22.9839 14.6501 17.4764 +310 1 1.00316 9.27987 10.329 14.3691 -27.2472 -11.0896 +311 2 1.16727 10.1904 10.5724 12.779 8.1681 -2.56256 +312 2 1.84996 8.76119 10.1498 -30.7163 35.51 10.5854 +313 1 16.8004 4.89338 8.19813 23.5039 -12.6505 29.7165 +314 2 16.1748 5.31624 8.83318 15.8467 -9.35353 -17.5774 +315 2 17.4877 4.38941 8.71628 -29.2517 16.802 -13.3541 +316 1 14.6379 14.6893 0.402347 -11.159 -0.978579 14.7724 +317 2 14.9609 15.3376 1.05877 0.0769081 -12.0935 -6.53519 +318 2 13.9048 14.1906 0.841144 15.9383 15.9909 -14.4014 +319 1 3.51181 11.0525 9.63829 2.1739 12.5105 -11.7746 +320 2 3.41507 11.3617 10.5484 4.86707 2.92948 -3.5212 +321 2 3.25155 11.8076 9.06383 -0.0479228 -15.275 7.06779 +322 1 11.0289 10.8695 1.26208 17.169 21.0662 -6.34954 +323 2 11.1535 11.716 0.753779 -4.03889 -27.9068 14.1765 +324 2 10.1142 10.5923 1.16471 -3.02205 2.54599 -1.38039 +325 1 13.2239 7.06188 12.8977 -30.3793 3.52384 -4.06516 +326 2 14.1381 6.84046 12.8922 25.6531 -5.59605 1.27225 +327 2 12.7471 6.22139 12.9668 3.13335 6.34025 -4.15647 +328 1 9.62584 1.88878 0.937813 20.0839 -1.09549 37.2578 +329 2 8.77484 2.11506 0.623903 -26.2152 1.3675 -15.013 +330 2 10.1764 1.70882 0.191067 9.10224 -0.512606 -16.4895 +331 1 10.6054 13.537 4.7508 -3.45661 -5.20977 -1.23778 +332 2 11.3208 12.9359 5.04367 -5.78837 16.6981 -6.98771 +333 2 10.4128 14.1619 5.47507 11.2154 -13.4565 -5.70688 +334 1 14.2525 1.6915 10.8868 25.1006 21.2848 4.13062 +335 2 15.0842 1.26497 10.6465 -4.75627 -8.22365 -3.1417 +336 2 14.5069 2.62992 10.8824 -13.5101 -4.08816 2.36647 +337 1 14.6678 12.4248 11.7157 -12.7858 -12.3306 -9.5252 +338 2 15.5574 12.5766 11.3177 -24.032 -11.5318 -4.29299 +339 2 14.0022 11.9667 11.1187 32.4402 16.632 10.9337 +340 1 8.24065 5.08218 9.78509 -7.81525 41.6802 29.5679 +341 2 7.45364 5.10173 10.3836 16.236 -11.1581 -20.3292 +342 2 8.36822 4.22882 9.41503 -10.4798 -31.0118 -7.50393 +343 1 1.59893 16.8132 18.3262 1.78713 43.6046 -19.4726 +344 2 1.99225 17.1675 17.4932 -13.4068 -2.95443 18.1753 +345 2 1.72693 15.8931 18.2458 9.12037 -33.6792 3.80865 +346 1 1.43382 17.2563 15.3383 70.3372 -10.1908 -13.5082 +347 2 1.32309 18.1562 15.5759 -5.39176 26.6374 11.2222 +348 2 0.623143 16.841 15.3782 -64.6751 -20.2725 0.847241 +349 1 3.73599 5.55499 6.2196 -13.8181 39.8005 -2.84681 +350 2 3.32092 6.26594 6.76194 2.21889 -20.7758 -8.723 +351 2 4.19567 6.05321 5.52665 5.67395 -4.434 2.61268 +352 1 12.357 9.41487 14.1826 15.3987 -29.3966 1.09302 +353 2 12.9591 8.63784 13.9021 -33.8501 34.209 16.2235 +354 2 11.936 9.15457 15.0346 16.6427 1.77305 -15.4117 +355 1 4.0362 15.2647 6.90572 33.8672 24.728 -7.08093 +356 2 3.45744 16.0249 6.7945 -6.17655 -1.99751 -5.28974 +357 2 4.92941 15.6518 6.66696 -29.006 -22.9584 9.78444 +358 1 0.606517 8.56128 14.8606 9.39684 15.8059 -8.30397 +359 2 0.498099 9.52604 14.9437 -1.87135 -9.61679 5.58044 +360 2 1.28855 8.50016 14.167 -9.83185 -6.21013 7.33103 +361 1 12.9763 8.3683 10.3434 1.19405 4.03237 -29.9304 +362 2 13.7163 7.90436 9.89822 -7.22584 1.47622 17.5396 +363 2 12.9003 8.0957 11.2534 8.23718 -11.529 10.7869 +364 1 15.2983 7.63672 3.47583 -36.323 -26.5913 31.5529 +365 2 14.5024 7.10501 3.29647 15.7237 15.5958 -25.1442 +366 2 15.2922 7.47095 4.43335 26.8259 14.207 -3.84044 +367 1 17.3208 6.63818 0.028906 -16.9884 17.5938 -6.80353 +368 2 16.7479 6.05403 0.554933 4.15554 3.30118 -7.73843 +369 2 16.7141 7.27151 18.2009 11.1968 -20.2911 18.275 +370 1 8.79355 6.92545 7.84172 -17.9944 -26.8715 17.7017 +371 2 9.63968 7.32585 7.85068 34.0918 14.4557 -5.0304 +372 2 8.77688 6.39871 8.67404 -5.99252 8.25367 -18.4431 +373 1 12.3209 0.607808 1.1741 -9.70621 -1.67076 -6.18378 +374 2 12.995 1.15082 1.58835 11.8921 -6.95349 3.94176 +375 2 12.79 18.5825 0.66073 -1.23695 5.23567 5.50046 +376 1 5.68514 15.097 14.5145 3.67475 30.0662 -16.0184 +377 2 4.72797 15.1695 14.4772 -3.92865 -1.97247 7.85561 +378 2 6.02476 15.8935 14.032 -4.97132 -21.5573 17.6103 +379 1 3.822 6.53853 1.67803 9.4136 -3.73603 -11.0507 +380 2 3.54968 7.33117 1.17576 -2.2757 -10.4776 17.1213 +381 2 3.81642 6.7886 2.60252 -0.785086 8.11893 4.5328 +382 1 3.89262 11.6088 12.227 13.3033 3.31132 5.82178 +383 2 4.72051 12.1032 12.348 -1.72331 -9.21471 -1.78635 +384 2 3.26281 12.0921 12.7526 -14.3078 7.33513 5.3451 +385 1 5.45444 3.88172 15.8755 10.9934 63.7886 22.8921 +386 2 5.90627 3.24049 15.3708 25.1493 -29.4334 -15.1609 +387 2 6.11665 4.65725 15.9739 -37.1513 -37.4972 -5.17498 +388 1 14.4636 10.317 4.39501 8.04256 -17.7362 -43.5508 +389 2 14.9051 9.88853 5.13417 -2.05112 -4.59794 0.583625 +390 2 14.7084 9.81768 3.53446 -13.0506 20.827 46.8358 +391 1 7.94949 17.2895 9.24469 -12.4073 10.6503 -4.49958 +392 2 7.23447 17.5423 9.86969 11.4984 0.663317 -18.2334 +393 2 8.01085 17.8889 8.47627 -8.74254 0.310971 13.2931 +394 1 4.4986 14.4237 3.96317 22.7921 6.59984 27.2073 +395 2 4.89523 15.3318 4.14709 -15.7294 -33.8816 -1.82578 +396 2 4.80237 13.7713 4.67129 -10.4496 32.1184 -24.135 +397 1 14.3358 7.38467 15.7635 24.4704 6.70756 7.84838 +398 2 15.2401 7.23754 15.391 -26.2451 3.74497 13.7384 +399 2 14.4998 7.83446 16.6232 -7.00308 -11.7114 -18.5693 +400 1 2.86875 18.2246 1.90934 8.22952 29.9251 46.5059 +401 2 2.54447 17.7626 1.17928 -17.7355 -34.6574 -39.0362 +402 2 2.08284 18.4154 2.45796 15.223 4.61378 -9.70941 +403 1 7.96139 1.61197 4.52525 29.4796 -3.5692 28.5612 +404 2 7.4985 1.83317 3.72811 -4.47294 12.8461 -13.1797 +405 2 8.84188 2.051 4.57628 -23.8244 -8.06079 -10.6756 +406 1 2.69247 14.1251 17.7583 -39.7925 -12.5472 14.0506 +407 2 1.78944 13.8074 18.0556 30.3506 3.26472 -13.0537 +408 2 3.33089 13.517 18.1683 -2.67461 8.7222 -7.81087 +409 1 0.711797 1.68055 13.8626 44.8563 0.102291 -15.8697 +410 2 0.854596 1.56791 14.7929 -2.34617 -4.64243 17.7358 +411 2 18.4557 1.86826 13.7064 -36.5874 5.33291 1.35002 +412 1 4.5582 18.5986 13.9691 17.69 -10.1212 -17.3986 +413 2 5.37614 18.0918 13.7297 -17.5363 18.7277 11.6893 +414 2 4.4096 18.4453 14.9034 -4.80692 -4.44744 5.40837 +415 1 7.10973 0.453475 18.3742 -17.6731 43.6393 33.9394 +416 2 6.99644 0.098599 17.5235 3.55611 -15.5456 -38.0778 +417 2 6.34312 1.05085 18.5323 11.5496 -19.3687 -0.295067 +418 1 16.0934 18.4421 14.1505 -13.5696 -24.3411 -34.6818 +419 2 15.444 17.7866 13.7542 20.5302 26.3107 23.9987 +420 2 16.0379 18.4915 15.109 -11.2087 -0.403296 -0.42938 +421 1 10.1156 4.52417 16.2956 -63.5341 -10.6596 -28.1335 +422 2 10.9808 4.34247 16.5381 54.6034 1.03427 17.4186 +423 2 9.84863 3.69679 15.8473 1.5569 12.8802 9.55133 +424 1 15.8226 17.9425 4.41327 -12.7412 7.89699 33.5898 +425 2 16.5547 18.5732 4.53052 -9.15632 -3.64108 -2.38506 +426 2 15.1071 18.2295 5.06915 28.1993 -15.1976 -35.9746 +427 1 6.9246 17.3574 13.7412 41.9162 15.5861 -1.52717 +428 2 7.49648 17.8115 14.4369 -23.1807 -22.4309 -23.3681 +429 2 7.52703 17.1963 12.9658 -13.588 5.84324 25.6525 +430 1 13.2892 6.57209 6.73437 -45.0771 -7.84691 9.23056 +431 2 14.2146 6.66317 6.83486 35.9508 1.69852 -11.4068 +432 2 13.0394 6.38579 5.82242 8.43649 1.47489 -3.25235 +433 1 7.6616 2.3861 9.17526 8.07841 -8.24756 -37.8228 +434 2 7.32169 2.39592 10.0555 -17.554 -3.79201 20.6206 +435 2 6.95914 2.1022 8.53308 18.9972 7.96045 22.8376 +436 1 15.1464 14.8771 13.6482 -9.08859 5.19149 1.30171 +437 2 15.0308 15.0223 14.6069 -2.64384 -0.244686 -12.5428 +438 2 14.3194 15.1152 13.1798 15.9342 -4.32482 12.4068 +439 1 9.29105 8.34315 3.70472 25.3147 -22.6228 7.1656 +440 2 10.1776 8.75859 3.73678 -14.6049 0.788849 -0.227964 +441 2 9.48378 7.39942 3.88081 -7.38963 16.6026 -2.51653 +442 1 17.6854 13.4687 16.4528 1.20699 34.422 -16.619 +443 2 16.7357 13.4337 16.3398 -3.15338 -8.61752 5.60033 +444 2 17.8844 14.3284 16.0065 4.30498 -21.0483 11.9174 +445 1 5.04883 10.6547 2.58751 21.171 -14.0773 3.70172 +446 2 5.87017 10.3468 3.04382 -23.0848 5.17759 -4.78185 +447 2 4.55197 11.1441 3.22928 -5.68041 9.33128 13.9497 +448 1 3.70566 8.3683 10.3381 2.8322 -31.099 -4.13864 +449 2 3.86061 9.29726 10.2176 3.71195 18.7597 0.626964 +450 2 3.86652 8.14601 11.2715 -4.70232 11.1023 -9.34814 +451 1 16.1079 7.11641 6.33859 19.1617 -15.4194 -14.8444 +452 2 16.7241 7.70559 6.80408 -7.69122 -6.37409 -7.38138 +453 2 16.6678 6.33083 6.12136 -24.1396 12.8226 8.63966 +454 1 15.2027 7.00502 9.1117 -12.4455 33.5656 -30.1004 +455 2 16.009 7.42176 9.46585 -11.7729 -5.93044 -7.51071 +456 2 14.9881 7.51375 8.25647 14.3105 -22.443 40.0586 +457 1 6.4525 13.1649 12.9201 -14.4212 4.62434 6.2224 +458 2 7.2977 12.7289 13.0561 -0.519457 -3.7562 7.19322 +459 2 6.25327 13.7237 13.7059 9.03992 -10.4089 -22.4145 +460 1 12.1145 4.49786 13.0694 60.1541 40.3897 -0.599702 +461 2 12.3852 4.68406 13.9868 -12.8154 -8.572 -1.53547 +462 2 11.3952 3.9317 13.0199 -51.9002 -33.7145 4.15206 +463 1 11.3323 8.18365 7.8522 33.2694 0.481688 12.7059 +464 2 12.0901 7.73501 7.43634 -16.2057 -1.97452 -6.97761 +465 2 11.7651 8.45102 8.68662 -20.5523 -0.0583287 -5.01537 +466 1 17.1666 10.776 7.42179 36.6255 -17.1838 -28.5238 +467 2 17.7906 10.0723 7.08441 -19.5131 16.2155 23.227 +468 2 17.2793 11.4524 6.73733 -13.1225 1.2547 8.82205 +469 1 5.22802 18.1471 11.05 -26.218 -15.3265 2.15414 +470 2 4.73762 18.1049 11.901 9.27461 0.443739 -18.2338 +471 2 4.62535 17.7417 10.374 18.9971 14.5949 15.121 +472 1 7.56653 17.6363 1.80821 2.05543 -3.48119 51.3305 +473 2 7.65741 16.7768 1.42856 8.63412 -18.3953 -16.9352 +474 2 7.35855 18.2549 1.13994 -1.30452 14.3677 -27.7338 +475 1 1.85092 12.9256 13.6076 17.4877 19.0754 23.2488 +476 2 1.72104 12.4156 14.4258 -6.17153 0.259213 -13.4945 +477 2 2.19932 13.7866 13.9501 -9.51965 -23.6336 -9.57422 +478 1 9.73868 6.79159 14.8001 -20.4051 42.5069 -0.796717 +479 2 9.95236 5.95211 15.1529 11.7083 -38.3225 9.01974 +480 2 9.967 6.84408 13.8723 6.06139 -4.97285 -7.43337 +481 1 15.2087 4.3972 10.7794 -26.9028 -24.0998 -25.0358 +482 2 16.0082 3.89203 10.8637 24.0661 5.32644 6.50358 +483 2 15.2102 5.16148 11.3322 8.70888 13.5856 17.3899 +484 1 11.1963 6.12482 0.150068 -24.122 -22.6006 13.7234 +485 2 11.2381 5.20796 0.481504 11.6671 13.7026 -10.2768 +486 2 10.2374 6.21547 18.6186 16.3103 12.5014 -3.12394 +487 1 0.19533 11.3359 15.1413 -21.6592 10.769 -30.7731 +488 2 18.4021 11.874 14.3993 14.4722 -20.1415 31.2795 +489 2 18.4481 11.661 15.9631 4.68348 9.49999 -5.94609 +490 1 7.06882 9.13032 7.26059 -22.6631 -3.09615 15.424 +491 2 6.55985 8.40099 7.69941 15.0645 18.9564 -17.5163 +492 2 7.9725 8.82922 7.21375 6.85038 -6.33336 0.902711 +493 1 18.4578 15.4507 12.3537 6.97015 0.808933 -7.22971 +494 2 0.776651 15.5698 12.2511 -16.5258 -3.56518 7.28193 +495 2 18.1456 15.6789 11.4721 -4.11121 -1.28038 2.68538 +496 1 16.5694 4.36967 5.25107 2.45626 -29.8761 41.2812 +497 2 16.7744 3.81151 6.06026 -19.4928 29.4804 -23.4548 +498 2 17.3898 4.32671 4.78168 14.6436 6.44337 -19.6343 +499 1 17.788 3.06911 10.7078 8.19486 16.3181 17.0759 +500 2 0.075758 3.1322 11.0257 -18.3141 -4.46618 -10.1687 +501 2 17.6332 2.20749 10.3226 7.04824 -10.7221 -5.22745 +502 1 12.3142 0.064083 10.1758 -16.6046 52.5698 5.40656 +503 2 11.3746 0.384648 10.259 27.2889 -19.3162 -0.832384 +504 2 12.8178 0.919304 10.3228 -10.5773 -40.3011 -9.47381 +505 1 10.3666 9.83315 12.2981 15.5663 4.35939 24.9446 +506 2 11.1015 9.85063 12.955 -12.9587 3.49885 -14.3711 +507 2 10.1328 8.91188 12.2898 -2.48305 -14.5784 -4.85859 +508 1 0.463654 2.82678 7.01839 21.5285 29.229 11.0876 +509 2 0.875324 3.58845 7.48211 -15.1018 -9.47019 -10.8481 +510 2 0.770257 2.12665 7.58365 -2.10845 -18.3887 2.87796 +511 1 0.478371 15.2358 6.91004 -5.05906 -57.415 8.40739 +512 2 0.585298 15.6463 7.75647 1.85019 10.3725 13.8373 +513 2 0.556531 14.2524 7.18353 -2.63305 52.383 -27.2731 +514 1 16.9534 7.00251 15.3394 -15.9191 6.08615 -6.45156 +515 2 17.6338 7.63543 15.0899 14.1822 -6.8729 3.83609 +516 2 17.3093 6.19568 15.7235 10.8839 2.85836 -7.52482 +517 1 9.0001 12.4151 8.13768 -31.1102 30.9609 25.8163 +518 2 9.37386 11.8218 7.49742 -5.17233 -14.4246 -22.3971 +519 2 8.02402 12.632 8.03373 38.2843 -19.0142 -6.47162 +520 1 1.27238 1.95406 3.05803 -13.5483 -7.94682 -18.4152 +521 2 1.26084 2.61511 2.34121 0.274888 -9.5029 12.9388 +522 2 1.89031 2.22344 3.73293 6.76618 11.1556 -0.474465 +523 1 4.13907 15.1156 9.62039 -21.6353 8.89781 12.928 +524 2 4.07003 15.1439 8.65747 6.73796 -2.17255 1.87071 +525 2 4.96029 14.7006 9.86457 13.8731 -5.89958 -3.36363 +526 1 7.17628 2.17866 14.5671 10.1969 15.6665 0.500505 +527 2 6.99528 1.68402 13.7698 -5.58163 -4.27811 -6.1139 +528 2 7.62131 2.98432 14.249 -3.31044 -9.5634 8.35677 +529 1 18.6082 14.7131 2.1481 32.6395 -16.0207 -3.46113 +530 2 0.838003 15.1297 2.25966 -5.15041 -8.02703 -3.38947 +531 2 17.988 15.3544 2.42675 -27.9684 22.1971 4.74449 +532 1 9.94138 2.79524 12.9422 16.7157 -19.9527 -5.96647 +533 2 9.79404 2.1456 12.2228 -2.63367 12.9584 8.66897 +534 2 9.17835 3.36299 13.0326 -7.96092 5.51528 -6.54514 +535 1 2.80444 8.90955 13.0076 -17.7822 -13.1167 0.317539 +536 2 3.06361 9.80599 12.872 10.5962 22.9278 -4.25378 +537 2 3.5122 8.48618 13.4775 15.1932 -9.60442 7.00981 +538 1 3.236 8.3574 3.63664 -2.86765 -22.2709 68.2353 +539 2 3.45085 9.0718 3.07326 14.564 28.9211 -13.7717 +540 2 3.47645 8.58669 4.60794 -11.4307 -4.68562 -51.1711 +541 1 5.62853 7.18594 8.51094 8.63755 21.4894 2.16978 +542 2 5.46784 6.31815 8.13889 -3.95344 -9.53044 10.3317 +543 2 4.96415 7.47792 9.15047 -3.24726 -12.0183 -2.29801 +544 1 14.8757 1.26039 2.01768 8.95967 6.82752 -28.1452 +545 2 14.9353 2.01952 2.56559 -6.40438 15.8227 28.9683 +546 2 15.2784 1.60993 1.21235 -4.35761 -14.1118 -5.79377 +547 1 8.22892 15.2012 0.850139 10.8537 -12.6178 7.38979 +548 2 9.02213 14.9338 1.33488 2.38301 14.3333 -0.830013 +549 2 7.55366 14.6663 1.27665 -9.08858 2.03607 -6.2405 +550 1 15.6387 1.34587 7.23673 -38.2068 -12.1482 -8.38322 +551 2 14.9277 0.724731 6.91269 26.6184 17.4884 8.18161 +552 2 15.1173 2.1119 7.53894 10.4663 -3.86302 -4.52487 +553 1 4.90142 13.0959 18.5232 17.6249 -4.01801 23.9701 +554 2 5.32755 13.082 0.76977 -10.7656 0.632793 -19.6876 +555 2 5.44764 13.7122 18.0259 0.499955 -3.74815 -4.96885 +556 1 15.3368 8.46948 18.1479 21.2409 26.352 -19.7425 +557 2 15.8061 9.12264 17.5623 -15.5364 -21.5252 11.6976 +558 2 15.3318 8.91689 0.353875 -5.84476 0.442576 5.05054 +559 1 12.0708 3.01842 18.3809 -8.91332 38.2285 -17.9492 +560 2 11.9316 2.65996 0.60646 7.08072 -18.979 4.32412 +561 2 12.6022 2.47389 17.7995 4.78982 -18.1658 8.07002 +562 1 13.2139 12.6752 5.17768 -9.57044 10.0795 -9.57129 +563 2 13.7464 12.0348 4.69253 1.60656 -5.44915 8.62561 +564 2 13.2564 12.5123 6.11793 10.4898 -3.48459 7.66387 +565 1 6.05443 7.0356 0.031519 0.0605761 -19.9038 6.17744 +566 2 5.93935 7.95118 18.5019 3.71712 34.2187 -1.98634 +567 2 5.39095 6.86665 0.702638 -7.83388 -10.1683 0.476271 +568 1 17.7528 16.0276 15.0213 -25.9758 6.2762 6.79882 +569 2 16.9476 16.5457 15.105 3.54626 -1.67183 20.5845 +570 2 17.7479 16.0055 14.0813 22.8568 -13.146 -30.1028 +571 1 13.196 0.994907 16.5363 6.37162 1.07879 13.9702 +572 2 14.1481 0.997912 16.7614 -14.4757 -4.73392 -6.84542 +573 2 12.8833 0.094199 16.7238 3.07394 5.84273 -8.05351 +574 1 11.1253 14.5647 7.20271 13.6513 20.7581 -19.5035 +575 2 10.4007 14.3183 7.72981 -32.979 -9.13798 24.3252 +576 2 11.7186 13.8255 7.26943 15.8912 -3.80541 2.99114 +577 1 17.5081 8.62849 2.08107 17.5857 37.593 18.6886 +578 2 16.6801 8.63471 2.55495 -11.5266 -11.0229 1.73392 +579 2 17.5233 7.88242 1.516 -4.85302 -28.502 -20.2632 +580 1 12.3547 8.01168 2.02213 2.8693 7.47745 -2.1033 +581 2 12.2384 8.8582 1.54611 -1.5199 -14.1485 9.25757 +582 2 11.9739 7.3152 1.48261 -4.60849 0.564674 -12.802 +583 1 11.8761 14.6165 10.3364 -1.28632 -27.1744 -11.0444 +584 2 12.1004 13.7873 9.81464 -15.5434 34.4502 21.6186 +585 2 10.8993 14.6888 10.473 22.8986 -6.0814 -12.7032 +586 1 6.89524 7.05211 15.6117 2.70483 5.93472 10.8866 +587 2 7.81004 7.26536 15.3122 -19.1207 -0.823892 9.8847 +588 2 6.66676 7.54167 16.4408 15.3743 -10.0989 -25.4065 +589 1 8.00326 4.73593 13.4743 46.2088 18.1039 21.0673 +590 2 7.23337 4.7302 12.9572 -37.1051 2.19442 -26.1447 +591 2 8.40671 5.62958 13.343 -9.63909 -26.9075 5.20654 +592 1 13.4128 12.1818 14.2522 -5.46405 -2.8504 7.05596 +593 2 12.9414 11.3292 14.2657 10.1901 3.29349 -5.65079 +594 2 13.7875 12.315 13.3696 -1.58979 -2.51674 3.72795 +595 1 14.8395 9.42189 7.30548 -10.1492 -33.0314 -14.9507 +596 2 15.7087 9.765 7.42505 18.3001 17.1245 4.25051 +597 2 14.2269 10.0768 7.57319 -16.3703 19.68 11.0075 +598 1 12.6526 17.0686 3.07252 -25.5483 38.6692 13.4046 +599 2 12.8376 17.5237 3.93373 3.7914 -19.7635 -24.6942 +600 2 11.9913 17.6958 2.63477 29.3498 -30.5169 14.5322 +601 1 1.15545 7.13838 17.4647 -1.30818 10.8795 -24.4228 +602 2 0.330359 7.36323 17.9184 3.51096 -10.352 -1.0007 +603 2 1.05514 7.47868 16.5422 2.6229 -4.15873 21.1004 +604 1 12.7562 5.15096 15.6457 46.9745 -3.15458 16.4241 +605 2 13.4512 4.55662 16.0315 -23.8856 11.8204 -16.5269 +606 2 13.2414 6.00335 15.5788 -13.869 -10.6853 0.37407 +607 1 2.53993 3.38757 4.97618 -24.4059 44.0626 48.9955 +608 2 1.7609 3.18232 5.58922 29.5313 1.39757 -24.0522 +609 2 2.84154 4.31546 5.27885 -6.94106 -48.8689 -12.2378 +610 1 8.33186 11.2983 13.4548 -25.447 4.99647 44.923 +611 2 8.4244 11.0562 14.4444 7.04045 1.38295 -54.395 +612 2 8.91168 10.8786 12.8197 20.7237 -12.5345 14.2107 +613 1 12.8689 1.31514 13.3384 4.70567 59.9078 -15.5432 +614 2 13.42 1.58034 12.5659 -9.46235 -19.1343 13.2352 +615 2 12.4231 2.17844 13.5496 8.70338 -32.6779 -3.58081 +616 1 6.34008 13.7169 2.14963 -19.3306 -6.11379 22.757 +617 2 5.63978 13.877 2.82959 17.9638 4.85668 -21.8758 +618 2 6.88351 13.0442 2.56282 8.57629 -2.48731 -1.94932 +619 1 15.9206 6.61444 12.7992 -23.3103 -26.3741 2.68057 +620 2 16.3106 7.25195 12.2393 16.9755 20.6681 -18.7226 +621 2 16.4213 6.59661 13.608 7.79648 1.05266 12.4236 +622 1 16.8298 0.712824 9.59482 4.79811 -22.8344 -3.47194 +623 2 16.8791 18.3713 9.72616 -6.98639 26.8255 -1.99774 +624 2 16.5452 0.8605 8.67269 -2.39382 -2.67689 10.2173 +625 1 6.14624 11.7631 8.37671 0.189841 -56.9827 6.97012 +626 2 5.32447 11.4591 8.84151 16.7156 13.8425 -13.046 +627 2 6.64226 10.8931 8.20176 -19.0535 39.3101 2.14415 +628 1 2.88754 8.61261 0.453821 12.2401 -11.553 -23.675 +629 2 2.45212 8.04764 18.3917 -4.84247 31.247 26.7064 +630 2 2.34875 9.28564 0.895642 -13.4946 -8.81401 -13.4914 +631 1 10.1674 10.4623 6.50123 4.87464 -2.88608 -13.8248 +632 2 10.6087 9.69731 6.89122 -0.620763 2.00125 4.93232 +633 2 10.4694 10.4636 5.56932 -5.34739 2.02001 15.3519 +634 1 6.7142 15.6951 6.55167 22.995 7.84961 12.6004 +635 2 7.14328 16.1838 7.27089 -9.73558 -8.55589 0.364412 +636 2 7.21237 16.006 5.79102 -10.9792 5.43097 -10.3878 +637 1 6.445 13.1807 5.57797 -3.32019 -20.8794 2.06608 +638 2 6.7301 13.9465 6.07331 -1.80129 7.88671 5.96843 +639 2 6.09943 12.5433 6.22286 1.13913 6.90777 -2.85329 +640 1 16.8242 12.5629 9.83758 3.36613 -21.9924 0.476486 +641 2 16.9985 11.8651 9.16533 -5.29916 18.5903 6.02329 +642 2 16.5644 13.3844 9.42716 1.61266 3.35571 -10.8679 +643 1 6.03738 2.95058 2.86354 -7.51536 -24.4327 -2.00067 +644 2 6.40977 3.757 2.57075 14.9417 32.1903 -3.64532 +645 2 5.57703 2.61747 2.09059 -4.23441 -8.07329 -3.19257 +646 1 10.9114 3.33767 3.30112 3.4906 -2.16377 5.30702 +647 2 10.297 4.02722 3.58926 -1.61521 -6.66566 -5.52383 +648 2 10.5127 2.84524 2.57795 -5.77666 1.81375 -3.43243 +ITEM: TIMESTEP +10 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.68194 7.08301 17.95 -9.31723 -4.61569 5.17534 +2 2 7.78696 6.81626 18.2438 14.604 4.05464 -8.83536 +3 2 8.80373 6.759 17.0506 -2.23465 -3.10488 4.80291 +4 1 18.5422 8.2512 6.84005 -1.85374 20.2636 49.1182 +5 2 0.133718 7.9438 5.98823 13.4692 -17.0673 -32.1853 +6 2 0.402402 7.78616 7.5434 -4.29735 0.835788 -17.7519 +7 1 8.38516 18.5522 6.81414 18.1861 9.65042 -3.37417 +8 2 9.3349 0.126592 6.72298 -16.1755 -3.42506 1.43069 +9 2 7.92248 0.594936 6.31239 0.819355 -0.881225 3.09059 +10 1 6.59178 1.84314 11.71 32.0023 -4.98621 -11.2566 +11 2 5.89352 2.36713 12.0513 -24.1224 14.8358 13.0259 +12 2 6.19214 1.0378 11.3953 -8.69892 -12.638 -2.90229 +13 1 7.13386 5.75674 2.33026 -14.5408 0.616599 17.9391 +14 2 6.48306 6.1089 3.01881 22.5383 -2.3727 -34.6055 +15 2 7.09544 6.2305 1.47237 -10.8297 -1.47351 21.389 +16 1 16.2171 10.1491 16.1328 -28.1801 3.24526 14.6911 +17 2 17.0032 10.2274 15.6211 19.8027 8.68317 -10.1896 +18 2 15.8342 11.0337 16.2804 9.6716 -6.93987 -4.62354 +19 1 10.6069 15.0266 2.30703 -4.98248 -17.7421 -7.27467 +20 2 10.5595 14.4209 3.0573 0.524935 2.03122 3.93242 +21 2 11.0455 15.8043 2.63229 7.74565 12.2645 5.86516 +22 1 17.1614 8.24714 10.3877 8.07926 1.42828 6.48104 +23 2 16.5623 8.78009 10.9215 0.0316367 4.64377 2.31684 +24 2 17.9785 8.76022 10.2824 -6.97801 -4.40732 0.702868 +25 1 14.8935 15.8724 16.3278 20.2214 -7.01151 6.5945 +26 2 14.0152 16.2142 16.2283 -22.9266 5.478 3.03945 +27 2 14.9126 15.3591 17.1528 -4.85523 2.97165 -4.07838 +28 1 12.1655 13.3835 0.413391 7.36911 -14.3954 12.824 +29 2 12.1103 13.7323 18.1651 -6.85057 6.78658 -3.29346 +30 2 11.6807 13.9152 1.05851 -4.03153 8.23708 -7.75902 +31 1 9.27599 5.36662 4.05276 -29.4571 7.127 11.0843 +32 2 8.67176 5.26931 4.85064 22.4619 1.60875 -30.6294 +33 2 8.67539 5.53054 3.28716 9.26602 -4.36827 15.8404 +34 1 1.82909 4.27439 11.6483 -10.3032 26.7578 -2.81239 +35 2 1.73625 5.21877 11.9337 1.99226 -22.9368 -8.90994 +36 2 2.3645 3.83767 12.2983 6.89168 -8.93952 11.7704 +37 1 1.96701 6.83625 8.36791 0.700563 -10.6105 -3.76521 +38 2 2.46094 7.16371 9.10974 5.61647 13.7513 9.96296 +39 2 1.91553 5.8986 8.57777 -2.9792 -4.95164 -6.48224 +40 1 5.40472 4.39468 7.93775 -13.5219 -10.4794 -16.6571 +41 2 5.47247 3.43369 7.82443 4.19114 6.69916 9.09153 +42 2 4.75726 4.62849 7.24994 8.09624 5.59982 9.8174 +43 1 3.2394 2.92305 17.5474 -0.484589 33.1528 15.1222 +44 2 3.93082 3.31406 16.9898 -0.722116 -4.79924 0.441987 +45 2 2.93778 3.68549 18.1255 3.8058 -28.2307 -17.5498 +46 1 7.46921 5.27133 6.11017 -1.04832 -15.5011 48.3459 +47 2 7.90561 5.59719 6.92877 -0.90713 11.0324 -30.0179 +48 2 6.96076 4.54233 6.5205 0.0145083 12.7024 -20.8234 +49 1 9.7753 7.02229 11.9825 10.38 0.905424 28.7819 +50 2 10.3185 6.36588 11.5577 3.53671 -5.58238 -7.94156 +51 2 9.14507 7.32646 11.347 -14.6838 3.32198 -19.6076 +52 1 14.1071 3.54759 8.03608 -23.8038 4.02857 -21.7378 +53 2 13.5341 4.25359 7.68722 9.9361 -9.73972 0.838395 +54 2 14.4214 3.88758 8.85457 11.6 9.53944 21.926 +55 1 4.79933 17.2591 4.02624 -13.379 0.496236 -8.73431 +56 2 5.57386 17.851 4.10922 -16.5825 -9.69995 -7.24814 +57 2 4.20396 17.5018 3.27728 17.9024 3.63898 12.5287 +58 1 16.5033 16.6227 10.0525 8.55043 -2.52252 -17.4646 +59 2 16.0579 16.4137 10.8501 -12.2091 1.77219 28.6058 +60 2 15.9447 16.1927 9.39741 3.82195 1.69594 -5.2917 +61 1 1.95551 4.92482 0.485806 10.2127 4.96395 -0.662752 +62 2 2.54163 5.27617 1.19707 -10.7364 -3.48306 -18.9921 +63 2 1.87778 5.63364 18.4632 -0.0680824 -4.88148 10.5435 +64 1 11.8064 13.3616 16.2803 -11.2011 -32.854 -16.2783 +65 2 11.3068 12.5375 16.4476 0.201944 14.5536 10.5803 +66 2 12.2047 13.1237 15.424 4.38621 16.2025 8.43328 +67 1 10.1065 11.0626 16.9483 14.8798 -23.3813 0.89342 +68 2 10.5718 10.2022 17.1278 -15.1514 23.106 -6.44625 +69 2 9.22125 10.8281 16.6474 0.614925 -0.65596 2.44857 +70 1 11.7253 17.5378 13.4688 -9.94093 -22.0621 2.41868 +71 2 12.2582 16.9669 12.8891 0.443382 11.1567 2.15207 +72 2 12.0419 18.4322 13.3705 7.56806 8.72697 -4.32807 +73 1 6.34321 9.31538 12.2256 -11.115 -24.1278 -16.4431 +74 2 6.95505 8.9709 11.5438 -2.74015 10.4344 10.5225 +75 2 6.7633 9.99127 12.7388 17.4243 13.1424 4.46627 +76 1 16.2194 12.7233 2.70094 -4.61478 -5.953 2.95318 +77 2 17.0002 13.1906 2.44934 22.4693 3.83429 -6.00104 +78 2 15.5655 13.415 2.69545 -17.2672 7.42791 2.42646 +79 1 0.634553 12.563 5.85853 -28.5577 11.9856 -12.6208 +80 2 0.914444 12.5082 4.92832 1.43228 -1.32003 11.8657 +81 2 18.3286 12.8558 5.76638 29.2028 -10.3468 5.65715 +82 1 5.19236 16.3841 18.4962 26.3246 -0.931967 -7.14386 +83 2 5.89246 15.8922 18.0344 -14.3156 -2.38899 -1.49205 +84 2 5.72254 16.912 0.454606 -10.9177 5.22319 5.94171 +85 1 0.515157 7.6307 4.06432 40.0561 19.3507 -22.9165 +86 2 18.554 8.04388 3.41083 11.6748 -7.97607 10.9949 +87 2 1.4672 7.83805 3.73432 -48.6916 -7.92141 18.8197 +88 1 3.14333 8.89821 6.52388 -38.7347 7.47588 -5.16066 +89 2 3.55606 8.61579 7.33755 0.264066 -1.79724 4.80444 +90 2 2.15121 8.92424 6.67318 38.4004 -3.38228 -2.38687 +91 1 7.3156 10.3041 16.1747 -22.5262 4.44621 22.8692 +92 2 6.53394 10.4783 15.6406 9.03524 -0.350523 -4.2891 +93 2 6.93671 10.3234 17.0875 14.5541 -1.9474 -13.7178 +94 1 11.1094 1.06061 5.00017 -8.33223 -1.63593 -20.1003 +95 2 11.1653 1.90766 4.53999 7.02718 4.91961 9.72987 +96 2 10.7116 0.517103 4.29895 3.46448 -7.62041 12.1963 +97 1 4.44086 2.70257 13.2121 -8.76198 -6.25056 -12.8305 +98 2 4.61839 3.20254 14.0253 0.411253 -15.6801 0.294236 +99 2 4.37598 1.71769 13.3483 2.92355 28.3656 12.0639 +100 1 8.41481 10.0299 1.78755 2.58083 -12.9704 20.4417 +101 2 8.40154 10.6596 2.53141 -0.930044 -1.16348 -6.83089 +102 2 8.61337 9.15635 2.20556 -3.35942 21.7495 -11.7521 +103 1 10.5245 1.75336 15.553 -8.62776 -1.95945 -5.61675 +104 2 11.4377 1.70086 15.8172 12.2485 -3.82632 7.39579 +105 2 10.5516 1.84495 14.595 -9.16331 1.82149 -1.12185 +106 1 2.77042 12.9421 7.75317 -7.76237 -6.33315 7.0975 +107 2 3.33238 13.5624 7.27685 -2.67968 -0.352894 -3.41328 +108 2 2.03777 12.7029 7.16368 7.79305 2.46945 -1.53229 +109 1 3.64399 11.6862 5.32015 -16.8384 -12.8234 -6.75612 +110 2 3.34983 11.0669 6.0167 8.99611 10.2661 -11.4747 +111 2 2.85416 11.8487 4.76712 13.6242 -0.0526402 5.20338 +112 1 6.87773 14.4784 16.8504 -8.96924 2.55968 -2.39612 +113 2 7.58262 13.8601 16.6681 3.90388 -1.06505 3.99858 +114 2 6.56163 14.7581 15.9821 -2.66358 -1.99085 3.97159 +115 1 14.1744 14.5416 3.41044 10.3942 -0.651763 -8.74467 +116 2 13.655 15.3132 3.20132 -4.79611 11.1016 -3.67227 +117 2 13.7666 14.1672 4.18264 -6.53868 -10.5118 9.50782 +118 1 8.26761 18.1769 16.0723 60.4333 -9.62543 6.95109 +119 2 8.90915 17.473 16.3173 -32.2452 -3.35667 -3.16806 +120 2 8.92378 0.250762 16.016 -23.6515 10.2222 -7.97846 +121 1 4.73314 1.61844 4.90498 10.4838 29.1168 -20.5116 +122 2 3.92346 2.13642 5.08344 11.5633 -7.75976 -5.77828 +123 2 5.26159 2.15735 4.23518 -22.3286 -21.1319 29.8735 +124 1 15.1246 12.8394 16.4387 17.4381 -4.51065 31.9511 +125 2 14.6778 12.9897 17.2989 -1.10989 -1.43715 -21.8055 +126 2 14.5277 12.6911 15.7205 -25.4533 -1.78625 -11.0751 +127 1 15.7863 18.3852 16.7922 25.908 13.3822 31.678 +128 2 16.4574 18.6243 17.5189 -32.4234 -15.7026 -31.1655 +129 2 15.6278 17.4293 16.8067 2.01305 5.51074 5.25351 +130 1 1.13886 1.13555 16.5514 1.07915 19.6556 20.6288 +131 2 1.93696 1.57732 16.8903 -4.88731 -5.90564 -11.4186 +132 2 0.480719 1.50241 17.171 6.36092 -10.7053 -11.3623 +133 1 18.0845 4.58532 15.87 11.914 -13.2929 -3.66508 +134 2 18.5793 3.94883 15.3177 -8.66069 11.808 8.70591 +135 2 18.5822 4.70936 16.6848 -0.518448 -1.56194 -3.55701 +136 1 12.2302 16.9486 16.128 -37.9176 -11.5423 26.3029 +137 2 11.3914 16.5899 16.5469 36.4287 7.40626 -6.62059 +138 2 11.916 17.193 15.2634 5.93841 3.5336 -18.1806 +139 1 15.8788 2.54988 17.9721 5.087 5.67773 0.124923 +140 2 15.7549 3.4391 18.3687 -1.45045 -15.8437 -11.8457 +141 2 15.6801 2.58174 17.0093 2.38633 7.36977 18.7833 +142 1 6.70786 13.8001 10.254 -2.60372 -2.62943 9.53833 +143 2 6.60649 13.5148 11.1732 2.18143 10.2669 -0.00882184 +144 2 6.57676 12.9909 9.76432 1.5038 -4.69959 -12.8892 +145 1 10.141 18.2121 2.80409 9.87418 27.4677 -18.8777 +146 2 10.2555 0.291999 2.14056 -0.137226 -16.5556 14.9505 +147 2 9.2689 17.8819 2.61553 -12.127 -4.1331 -0.131977 +148 1 2.97228 17.7542 6.06181 -6.28377 0.301135 37.0401 +149 2 2.07671 17.601 5.72694 10.6784 2.25774 -14.0772 +150 2 3.63482 17.801 5.37776 -0.270923 -2.52512 -18.6151 +151 1 12.5659 17.001 7.96656 -23.415 -18.3905 24.197 +152 2 11.9071 16.2804 7.97312 11.7411 4.46809 -11.7089 +153 2 12.3405 17.4671 8.78984 12.2149 7.72109 -10.0441 +154 1 14.887 15.2779 8.2893 -14.8827 1.47652 2.73183 +155 2 14.0296 15.7117 8.25541 -5.1427 0.792443 13.0916 +156 2 15.1979 15.4906 7.42354 24.2513 -3.00083 -20.068 +157 1 17.5454 18.3111 0.374663 -13.7707 -4.14946 -2.00055 +158 2 18.2555 17.754 0.11924 20.0055 -25.3354 -15.9225 +159 2 18.0059 0.295965 0.896687 2.592 26.2966 16.2474 +160 1 0.909555 10.373 1.4127 -25.0541 -38.6286 23.1399 +161 2 0.0989843 9.87796 1.71715 28.402 10.794 -7.01331 +162 2 0.540787 11.0804 0.922273 -7.26144 30.0328 -22.846 +163 1 1.56438 12.1819 3.32547 9.10171 15.3717 9.49092 +164 2 1.376 11.5384 2.66679 -5.32309 -27.3061 -8.25977 +165 2 1.61002 12.9703 2.79202 3.36268 15.5511 3.76031 +166 1 0.549815 17.2556 4.8751 10.3167 15.4421 -19.2536 +167 2 -0.00199658 17.9163 5.26632 -10.5855 22.2192 -2.30371 +168 2 0.434878 16.519 5.43169 0.723696 -37.6018 20.4622 +169 1 1.10394 1.00198 9.3932 22.7427 9.86492 -7.57605 +170 2 1.42144 0.685439 10.2466 -8.09769 -6.36772 6.76546 +171 2 0.213433 0.697197 9.27667 -15.9263 -9.88137 4.21803 +172 1 16.7947 2.33275 13.2864 3.73194 4.84267 -27.3174 +173 2 17.0439 2.54012 12.3481 -6.98409 -4.39606 26.1758 +174 2 16.4729 1.42155 13.294 0.162444 -0.657512 2.21945 +175 1 2.4659 15.8297 12.1956 27.3811 -11.2673 13.1923 +176 2 2.9226 15.5311 13.0144 -9.82996 7.11615 -19.573 +177 2 2.93231 15.4201 11.4444 -5.86947 6.23921 4.54204 +178 1 16.4361 15.5441 5.94616 -3.08145 19.3328 -8.8947 +179 2 17.3593 15.4783 6.2724 -11.5576 7.7283 -8.52746 +180 2 16.3183 16.2893 5.29043 11.1937 -18.2696 22.1006 +181 1 5.84475 5.01999 11.7951 -3.08481 -3.45829 -4.75382 +182 2 5.52388 5.87345 12.0737 0.2772 11.9484 7.56792 +183 2 5.11411 4.43946 12.0133 1.47645 -8.9756 -0.689037 +184 1 15.224 4.86392 0.726277 -25.4938 -12.7349 25.4219 +185 2 14.7355 4.51715 1.53205 23.492 12.9767 -22.6649 +186 2 14.5328 5.02763 18.7193 1.17802 2.78752 1.94947 +187 1 16.3449 16.2967 2.11437 10.483 7.37611 -22.6614 +188 2 15.9997 16.7982 2.83675 -10.4405 6.50893 22.1211 +189 2 16.6677 16.9984 1.52582 -1.93062 -9.0043 0.169523 +190 1 0.302094 4.87802 3.79689 -13.2533 37.9479 3.00012 +191 2 0.313912 5.8808 3.95538 6.86913 -44.9842 -7.10747 +192 2 1.1462 4.49233 4.0346 3.71094 3.5442 4.02727 +193 1 2.9221 14.9895 15.0397 8.46471 -6.33736 14.5665 +194 2 3.00495 14.6058 15.9566 -9.31495 16.4585 -22.1508 +195 2 2.45729 15.8402 15.0938 1.85721 -3.29548 9.95349 +196 1 1.12 14.5717 9.56227 17.989 48.8934 -19.0037 +197 2 2.07414 14.5222 9.32346 -20.956 -13.4859 7.84449 +198 2 0.791626 13.7731 9.9282 4.87275 -29.8773 11.3577 +199 1 13.6624 16.6636 11.5457 -10.5327 9.77879 -22.0557 +200 2 13.3286 17.4311 11.0186 6.18992 -14.9435 17.5347 +201 2 13.3805 15.8992 11.021 -2.34987 0.215756 7.80532 +202 1 4.73359 1.47857 0.718618 -25.3973 -6.06392 2.87887 +203 2 4.17185 2.00661 0.129453 7.95287 0.81937 2.61464 +204 2 4.09095 0.858388 1.12753 14.212 5.94905 -1.43657 +205 1 1.42476 18.4735 11.9056 -5.99404 19.5083 -8.93412 +206 2 1.23513 0.382953 12.6723 -0.378912 0.915416 0.341246 +207 2 1.89505 17.7259 12.2433 7.21066 -16.1249 4.04173 +208 1 11.5448 10.106 4.11346 25.2596 15.8213 -25.5125 +209 2 11.5283 10.5663 3.22641 -2.70186 -14.3529 26.6987 +210 2 12.5027 10.081 4.37886 -27.2068 -0.404219 -8.52489 +211 1 8.37485 12.1748 3.75184 -11.9448 24.9759 46.3975 +212 2 9.17743 12.5878 4.11803 1.10724 -8.54244 -18.9118 +213 2 7.75197 12.4339 4.49102 7.61965 -18.0915 -33.0697 +214 1 14.3244 4.03247 3.293 11.3964 4.48411 20.4985 +215 2 14.943 4.18459 4.05162 -10.8147 -3.75721 -20.4981 +216 2 13.4909 4.45368 3.55282 4.29688 -1.92648 -2.70238 +217 1 5.58313 1.77339 7.50694 -37.3093 -46.6507 29.7736 +218 2 4.97145 1.12464 8.0478 36.2685 39.0776 -31.448 +219 2 5.37556 1.59155 6.57949 1.79923 3.69516 -0.386563 +220 1 17.9058 1.11523 4.88403 9.14173 18.8744 -7.73144 +221 2 18.4454 1.57607 4.20954 -6.0377 -15.1011 6.62684 +222 2 17.7347 1.81107 5.53023 -2.74058 -7.94095 2.09707 +223 1 6.8279 9.39776 4.48823 3.62694 -0.974221 -6.28613 +224 2 6.84568 9.51125 5.43283 -7.5389 4.30482 14.2207 +225 2 7.717 9.07508 4.31798 2.90721 -0.358573 -8.96695 +226 1 2.70207 14.9601 1.96467 9.48597 -9.94138 -22.1344 +227 2 3.35633 14.7518 2.62888 0.238693 -0.206349 10.2383 +228 2 3.16249 14.7444 1.12616 -13.7934 7.99556 12.9651 +229 1 17.2754 12.8959 13.1352 7.09139 -37.5845 3.69594 +230 2 16.3537 13.1102 13.3148 3.80173 19.6017 -1.81888 +231 2 17.838 13.6507 12.9698 -8.26303 20.1956 -1.14982 +232 1 15.0171 10.5799 1.38486 -27.8548 -28.8799 -20.6854 +233 2 15.5438 11.2121 1.82149 21.7425 28.5078 17.6295 +234 2 14.2994 11.069 0.967203 2.72678 -1.55793 4.42244 +235 1 5.71388 6.94387 4.52744 5.06868 -23.5408 12.0019 +236 2 5.87421 7.87915 4.41499 3.45829 8.88765 -0.888191 +237 2 6.40286 6.63416 5.14703 -8.303 0.627238 -7.76707 +238 1 8.10838 8.26645 10.1831 -2.58942 7.80898 11.2224 +239 2 8.62669 8.8788 9.66253 10.4484 9.83111 7.1505 +240 2 7.63286 7.80673 9.50478 -12.057 -13.4779 -6.03182 +241 1 13.5281 18.2914 5.80176 -22.4215 -1.8227 14.6872 +242 2 12.749 0.212336 5.63336 9.50875 -1.85743 -1.68773 +243 2 13.2346 17.7232 6.55015 8.07385 12.1374 -16.5266 +244 1 0.320637 2.55746 0.113707 -24.4854 52.0087 1.52013 +245 2 18.0083 2.70852 18.6241 7.28296 -16.9077 1.12853 +246 2 0.626424 3.4996 0.197011 8.79214 -31.4205 1.87945 +247 1 12.6453 10.9632 9.76861 -25.4211 42.834 -14.9231 +248 2 11.6492 10.8795 9.70071 37.3368 -7.50244 3.90461 +249 2 13.0228 10.1402 10.0352 -3.08107 -28.1376 6.91694 +250 1 0.78452 12.2807 11.0864 19.7349 -6.9692 -1.93691 +251 2 18.4749 12.3028 11.1225 -11.4863 3.49833 6.83674 +252 2 1.15231 12.659 11.9029 -10.6903 -3.95248 -3.68276 +253 1 5.04293 7.22507 13.482 3.09598 5.99749 -4.73795 +254 2 5.58886 7.93262 13.132 -0.232718 7.71962 -10.0141 +255 2 5.52798 7.00144 14.2755 -0.932575 -7.50807 9.86229 +256 1 1.28071 6.97469 11.8373 -31.3117 -37.3004 -11.5925 +257 2 0.492113 7.17802 11.3051 9.94401 -3.39318 6.90536 +258 2 1.685 7.80152 11.9673 18.2328 34.095 8.03536 +259 1 15.4541 9.47192 12.3133 5.85738 22.5951 5.06509 +260 2 15.5175 10.4638 12.3742 -4.62374 -31.0112 4.63394 +261 2 15.4968 9.06746 13.1992 -1.35817 12.6181 -10.5463 +262 1 16.6442 12.9519 5.45538 -21.4717 15.277 -31.3145 +263 2 16.3435 13.8787 5.41602 10.8128 -9.57177 19.5795 +264 2 16.428 12.7198 4.52965 10.5011 -15.0883 17.3079 +265 1 6.17539 10.0558 0.19339 -10.2788 -9.80575 -26.1597 +266 2 5.38875 10.4515 0.589333 6.07089 -1.52504 2.9393 +267 2 6.86188 10.0925 0.84877 11.0601 2.17112 10.8149 +268 1 12.366 6.05676 4.0416 -22.1854 -19.7968 12.9024 +269 2 12.3704 6.78834 3.44644 3.0333 22.1434 -14.5586 +270 2 11.4296 5.77117 4.03801 16.8285 0.174707 3.6691 +271 1 0.132536 12.8255 0.204274 -0.526736 3.63462 -3.55478 +272 2 -0.0162245 13.5547 0.824079 2.12041 -2.82991 -1.20796 +273 2 18.2367 13.045 18.0704 5.31007 -1.26571 4.82883 +274 1 3.83823 18.58 8.61434 -10.0824 -4.97514 -18.4016 +275 2 3.52069 18.2861 7.74382 9.30441 -4.40092 2.94392 +276 2 3.03757 0.306881 8.974 -6.88025 7.19874 10.2509 +277 1 7.39362 17.2775 4.45212 12.7302 8.58303 13.7229 +278 2 7.99666 17.968 4.81801 -14.6435 -15.1886 -20.2263 +279 2 7.36047 17.3088 3.48385 6.79225 7.50625 8.12072 +280 1 9.21958 17.0373 12.2266 15.7968 3.09867 9.11932 +281 2 9.35553 16.2013 11.7334 2.65662 13.4997 9.89778 +282 2 10.0046 17.242 12.8046 -16.9951 -13.4125 -19.4407 +283 1 13.3157 13.0082 7.94027 -17.3901 -31.9016 7.67948 +284 2 13.1929 12.2449 8.54147 -2.27359 6.97807 -8.06923 +285 2 14.1396 13.3907 8.1966 15.275 17.864 3.60781 +286 1 14.9833 2.94943 15.3513 6.95235 -3.03472 -25.2367 +287 2 14.3042 2.39498 14.9448 0.627233 -0.993788 8.39197 +288 2 15.6656 2.99789 14.6444 -10.442 2.78752 17.6131 +289 1 9.85751 15.5027 17.0048 6.47201 6.54967 -7.92386 +290 2 10.2825 14.6779 16.7304 0.0104739 2.25127 2.62159 +291 2 9.29444 15.3215 17.7618 -3.54568 -3.88732 3.90928 +292 1 11.2881 8.2507 16.5469 4.08161 11.4658 1.26949 +293 2 10.784 7.71518 15.9432 -10.4144 -1.78397 -10.2593 +294 2 11.7122 7.60386 17.1014 6.56418 -3.83522 10.5232 +295 1 3.78473 18.1936 16.723 -4.68023 16.7202 -12.0174 +296 2 4.25527 17.5912 17.2966 7.9068 -1.91441 12.6846 +297 2 3.78787 0.451609 17.087 5.31404 -15.3334 2.54941 +298 1 2.1979 4.10843 8.95106 26.9406 -12.5237 33.2314 +299 2 3.04044 3.62982 8.81286 -17.1971 13.1508 -10.8815 +300 2 2.16124 4.09638 9.93984 -10.9226 5.8942 -24.7105 +301 1 9.90906 10.3512 9.74092 -24.4032 35.3078 2.18412 +302 2 9.42476 11.1784 9.45919 17.314 -27.1904 0.11143 +303 2 9.91744 10.4013 10.7102 5.12409 -5.92526 -7.2544 +304 1 9.73754 0.812356 10.8589 -9.45704 -2.93658 -4.01088 +305 2 9.44076 18.5949 11.1517 4.40065 -9.39685 13.0528 +306 2 9.08713 0.996724 10.1835 0.761981 14.6946 -8.69624 +307 1 9.19301 15.2105 10.2107 -22.2036 -10.0383 -7.82623 +308 2 8.98025 16.0713 9.80369 1.46967 -14.8527 4.99479 +309 2 8.36662 14.6679 10.1029 23.0402 13.9843 6.10558 +310 1 0.991303 9.28993 10.3284 48.5242 0.758788 -7.3086 +311 2 1.23965 10.2015 10.4879 -14.9681 11.3684 1.41472 +312 2 1.89881 8.9146 10.1688 -36.1698 0.796544 3.16897 +313 1 16.8183 4.88742 8.19443 14.5542 -10.1877 33.2312 +314 2 16.1728 5.34475 8.77937 11.7085 -6.30946 -17.3069 +315 2 17.4003 4.3619 8.8005 -18.9368 13.5764 -18.1776 +316 1 14.6428 14.6932 0.395223 -8.43601 -1.47433 8.87339 +317 2 15.0319 15.2579 1.0921 -3.12605 -9.09789 -8.18687 +318 2 13.8519 14.2576 0.787234 16.4944 11.1317 -8.84191 +319 1 3.51972 11.0527 9.63241 -0.0258339 11.398 -8.76826 +320 2 3.50143 11.4368 10.5206 2.13389 -0.105265 -4.21661 +321 2 3.1724 11.7459 9.02999 3.72912 -11.0816 8.2725 +322 1 11.0404 10.8634 1.27208 6.70694 17.4362 -9.49329 +323 2 11.1727 11.6824 0.735781 1.31404 -20.4369 14.6488 +324 2 10.1116 10.6362 1.15363 0.362803 -1.95542 1.92755 +325 1 13.2201 7.06705 12.8916 -20.9652 2.88797 -6.38338 +326 2 14.1438 6.85164 12.9216 15.9393 -3.58362 1.12932 +327 2 12.7477 6.22232 12.897 3.28641 3.49729 -0.863357 +328 1 9.62872 1.89177 0.948251 6.96093 0.24991 16.0649 +329 2 8.76715 2.00519 0.577625 -19.1552 -2.18542 -3.65809 +330 2 10.1854 1.76875 0.19003 12.4655 1.79214 -8.44775 +331 1 10.594 13.5319 4.7375 16.0423 -1.41644 13.6035 +332 2 11.415 13.0379 4.93682 -11.8157 3.93147 -13.4525 +333 2 10.5255 14.1008 5.52348 -3.94863 -4.31219 -11.1546 +334 1 14.2685 1.70153 10.8945 -3.08057 3.85383 7.15216 +335 2 15.0552 1.23258 10.5836 3.50278 10.8149 -1.53255 +336 2 14.4104 2.66429 10.8947 7.37053 -8.35752 -2.77651 +337 1 14.6611 12.4198 11.7249 1.4364 -26.5965 -56.3444 +338 2 15.4897 12.4837 11.202 -5.7241 6.85295 22.6084 +339 2 14.0924 11.9909 11.0313 1.01548 12.4899 31.9742 +340 1 8.24953 5.08668 9.79072 -30.3058 0.287699 22.814 +341 2 7.41708 5.03925 10.3073 16.545 17.0491 -5.32162 +342 2 8.22462 4.2143 9.42755 11.9131 -18.3304 -16.4659 +343 1 1.59402 16.8187 18.3253 -6.20255 31.6963 -6.78121 +344 2 1.91227 17.2067 17.482 -4.95179 -10.2412 13.7563 +345 2 1.83336 15.9037 18.3179 8.32765 -17.6711 -3.36436 +346 1 1.43897 17.2464 15.3358 29.6054 -7.17934 -6.21787 +347 2 1.36087 18.1379 15.637 5.97318 20.4573 7.89508 +348 2 0.556137 16.9475 15.3273 -33.612 -15.1267 -3.09538 +349 1 3.72895 5.57357 6.20543 -8.92972 12.8219 1.61975 +350 2 3.23079 6.21113 6.76482 10.0758 -7.74032 -14.0976 +351 2 4.28418 6.06511 5.5772 -4.67021 4.78615 6.0759 +352 1 12.3529 9.4251 14.1822 19.6727 -43.1834 10.5387 +353 2 12.884 8.61082 13.8993 -22.621 36.8155 4.19437 +354 2 12.0516 9.14148 15.0731 3.60544 11.6456 -14.396 +355 1 4.03531 15.2728 6.90881 24.4865 3.71204 -3.62934 +356 2 3.44033 16 6.68284 5.60112 1.73001 -3.29651 +357 2 4.96253 15.5542 6.68078 -28.8575 -4.96404 7.1648 +358 1 0.605953 8.56457 14.8638 -0.120582 -0.391313 3.99343 +359 2 0.501042 9.52227 15.005 5.35221 -7.46858 -4.68281 +360 2 1.25554 8.44629 14.1506 -6.09669 6.93914 6.70414 +361 1 12.9734 8.36578 10.3368 20.5003 -18.2509 -7.79226 +362 2 13.7393 7.86937 9.99522 -8.8873 10.1321 -9.444 +363 2 12.9708 8.03443 11.231 -10.3099 3.90117 14.6287 +364 1 15.2894 7.6332 3.49269 12.7581 18.2329 -13.143 +365 2 14.5338 7.17315 3.08677 6.1918 -0.800492 21.6775 +366 2 15.5136 7.51531 4.43453 -15.4019 -14.7068 -6.3771 +367 1 17.3212 6.64473 0.0316567 -27.1824 12.6283 -1.8657 +368 2 16.771 5.99448 0.499966 9.26154 0.672542 -4.32476 +369 2 16.64 7.24337 18.2783 17.9792 -11.5061 8.92142 +370 1 8.80668 6.92454 7.83918 -24.3908 -17.2325 7.20576 +371 2 9.68081 7.28212 7.80962 25.7376 5.86496 2.86911 +372 2 8.71775 6.37228 8.64787 6.10597 9.33115 -12.275 +373 1 12.3202 0.615137 1.17425 13.6931 -3.72396 -2.19539 +374 2 13.075 0.992886 1.63957 -0.40119 2.44364 5.09949 +375 2 12.7571 18.5667 0.666384 -10.9298 0.853201 -1.96514 +376 1 5.6785 15.1027 14.5126 8.23045 15.6484 -5.86338 +377 2 4.72039 15.1784 14.5966 0.299323 4.01186 0.94539 +378 2 6.04535 15.9236 14.1081 -12.4379 -14.8055 10.7649 +379 1 3.83406 6.52943 1.68496 -5.12703 10.9404 0.999964 +380 2 3.44824 7.31709 1.2662 3.88585 -11.3877 -2.55221 +381 2 3.84338 6.82178 2.59771 5.33619 -6.06857 7.79227 +382 1 3.88904 11.6132 12.2401 8.95627 -8.79814 -2.40389 +383 2 4.75841 12.0277 12.3683 -7.0992 0.0294616 4.018 +384 2 3.233 12.1226 12.7151 -2.84239 9.6423 6.84851 +385 1 5.44987 3.87776 15.8711 9.04603 51.7105 12.2927 +386 2 5.99752 3.20763 15.4917 15.5436 -17.9801 -7.19396 +387 2 6.04703 4.69158 15.9698 -28.7283 -34.9666 -5.01916 +388 1 14.4605 10.3225 4.39641 11.4537 -30.5762 -31.9722 +389 2 14.8306 9.83502 5.14205 -5.39586 2.29688 2.9797 +390 2 14.6901 9.75629 3.58792 -12.4512 26.4694 34.1579 +391 1 7.94485 17.2962 9.23406 -29.3852 32.3044 -4.90329 +392 2 7.20157 17.582 9.8013 11.6936 -12.8295 -3.21694 +393 2 7.93254 17.9646 8.52624 8.85814 -10.3239 0.926379 +394 1 4.49873 14.4249 3.9575 27.1774 17.1098 41.9883 +395 2 4.83669 15.3326 4.20793 -17.2661 -25.1881 -14.2087 +396 2 4.80599 13.8528 4.71739 -13.53 13.4591 -29.2523 +397 1 14.3284 7.3854 15.7629 16.5671 6.07561 9.97379 +398 2 15.2454 7.23106 15.4511 -19.609 3.15959 8.32151 +399 2 14.4426 7.80786 16.6389 -4.4507 -8.27801 -15.1382 +400 1 2.87403 18.2247 1.90389 13.9577 30.3231 32.1513 +401 2 2.546 17.6397 1.25326 -17.0615 -24.6646 -23.5795 +402 2 2.12038 18.5502 2.43008 9.19244 -2.23706 -9.85686 +403 1 7.96361 1.60549 4.53489 27.0952 14.1367 0.307488 +404 2 7.49638 1.9472 3.77739 -15.4877 0.180801 -4.55719 +405 2 8.8215 2.06687 4.46869 -11.5471 -13.5362 7.94734 +406 1 2.67177 14.1298 17.7578 -32.0965 -17.6674 6.84649 +407 2 1.82063 13.6639 17.9969 26.9839 12.0838 -7.18622 +408 2 3.38659 13.5743 18.1098 -5.52669 6.70603 -3.66321 +409 1 0.723551 1.68725 13.8621 17.7332 3.27009 -2.43746 +410 2 0.829271 1.51069 14.7908 7.98206 -4.95309 12.0999 +411 2 18.44 1.84118 13.7764 -20.4783 4.25661 -8.09669 +412 1 4.55406 18.6 13.9636 17.2604 -7.63309 -9.35161 +413 2 5.43897 18.1924 13.8214 -18.4623 11.1021 3.79828 +414 2 4.32329 18.399 14.8757 -4.15164 0.0521115 2.41255 +415 1 7.10455 0.474046 18.3679 -11.2359 27.2348 29.1061 +416 2 7.12016 0.115813 17.4965 -1.63433 -6.1865 -23.0052 +417 2 6.24271 0.910062 18.5515 12.5771 -12.8936 -7.91243 +418 1 16.1005 18.44 14.1333 -36.4501 -27.5791 -6.57953 +419 2 15.3829 17.8174 13.8465 25.6281 20.8019 -1.7164 +420 2 15.9077 18.5395 15.0719 9.49834 8.44163 -0.14337 +421 1 10.1046 4.52059 16.2893 -46.9792 2.1543 -16.8809 +422 2 11.0012 4.49779 16.5541 31.7343 -4.51398 5.87687 +423 2 9.86248 3.65729 15.9089 12.0807 6.21086 8.83226 +424 1 15.8363 17.9271 4.41684 -16.1004 8.03032 22.5493 +425 2 16.5039 18.6299 4.52246 -8.60661 -6.24751 -1.3813 +426 2 15.0378 18.2098 4.9532 29.0614 -11.0784 -22.6438 +427 1 6.9284 17.3613 13.7353 43.359 11.4946 7.60179 +428 2 7.46858 17.7163 14.5015 -21.3841 -13.8198 -23.6549 +429 2 7.59514 17.216 13.0184 -16.6797 3.36376 18.1603 +430 1 13.2847 6.56451 6.73769 -14.228 -11.1924 -15.3605 +431 2 14.2169 6.67596 6.68467 27.6084 8.49537 10.422 +432 2 13.086 6.40899 5.80997 -14.9004 -1.60425 -0.509451 +433 1 7.67719 2.38409 9.18276 -12.7481 -9.95901 -21.449 +434 2 7.23781 2.34079 10.0234 -2.84678 0.492631 19.9336 +435 2 6.97018 2.11077 8.55354 21.5545 6.86467 6.74712 +436 1 15.1528 14.8764 13.6487 -19.1236 6.62595 6.09279 +437 2 14.9964 15.042 14.5941 6.3649 -1.885 -8.0702 +438 2 14.3208 15.1168 13.2045 14.5757 -4.46306 2.19701 +439 1 9.29857 8.33432 3.70772 10.6355 -8.13532 4.49802 +440 2 10.1502 8.81328 3.76286 -8.0776 -10.0517 2.73632 +441 2 9.46492 7.39019 3.89736 0.427871 14.9166 -2.52044 +442 1 17.6858 13.4785 16.4504 18.1421 12.8824 -2.9019 +443 2 16.7336 13.3749 16.3876 -0.564153 6.32044 -4.53985 +444 2 17.9415 14.3223 16.0098 -13.7235 -15.3212 6.57805 +445 1 5.04165 10.6569 2.59879 15.0811 -13.5005 18.1704 +446 2 5.79991 10.2916 3.10884 -13.8602 3.81488 -12.1379 +447 2 4.57944 11.1735 3.25148 -7.64374 9.33605 4.93504 +448 1 3.71156 8.35988 10.3223 2.69392 -10.4458 7.32 +449 2 3.86762 9.29314 10.1995 2.90356 12.3134 -9.75827 +450 2 3.79851 8.25131 11.2818 -4.19061 -2.88345 -8.87222 +451 1 16.1009 7.11278 6.31821 6.57165 -19.5926 -13.3215 +452 2 16.7556 7.67982 6.75754 -3.32154 -9.30994 -6.24555 +453 2 16.5222 6.22545 6.20359 -10.7974 20.4957 5.39095 +454 1 15.1877 7.01217 9.11633 -0.942582 31.3193 -31.4924 +455 2 16.0087 7.4094 9.45282 -9.93766 -6.26011 -0.320925 +456 2 15.0368 7.51069 8.25256 3.47491 -21.9129 34.3614 +457 1 6.44498 13.1525 12.9077 -4.11711 1.46333 8.37594 +458 2 7.24124 12.6683 13.1519 -1.65948 -2.61146 -1.33868 +459 2 6.29723 13.796 13.6274 -0.63037 -8.66373 -16.4588 +460 1 12.122 4.49686 13.0678 27.186 16.1548 19.2119 +461 2 12.2551 4.61131 14.0219 7.12074 5.87928 -4.56992 +462 2 11.3374 3.99971 13.0395 -36.5276 -21.5475 -13.6693 +463 1 11.3413 8.18743 7.85231 -9.00357 4.77407 0.37365 +464 2 12.0188 7.6639 7.39095 2.25052 4.68793 14.2505 +465 2 11.6381 8.44006 8.74837 5.13859 -10.097 -12.5363 +466 1 17.1781 10.7776 7.41775 8.98079 -10.5429 4.93206 +467 2 17.827 10.053 7.20793 -14.7505 26.0455 -2.01259 +468 2 17.1485 11.4724 6.73654 6.61625 -12.2683 -1.04931 +469 1 5.23072 18.1435 11.0535 -19.1878 -10.0323 -1.26774 +470 2 4.70405 18.0783 11.8789 8.35901 -0.713622 -15.9457 +471 2 4.65273 17.8196 10.3204 13.2116 10.9899 16.482 +472 1 7.5638 17.6255 1.82385 0.18941 -4.57957 5.58349 +473 2 7.78527 16.8134 1.38126 5.66428 -18.4097 -0.230917 +474 2 7.45334 18.2192 1.09148 -1.66074 15.0057 -4.75644 +475 1 1.8616 12.9257 13.6096 9.14642 8.79388 9.51824 +476 2 1.6025 12.3584 14.3568 1.58601 7.25854 -8.04733 +477 2 2.19519 13.7677 13.9951 -8.21693 -20.1216 -3.01678 +478 1 9.73071 6.79429 14.803 -9.96431 20.7294 -5.24946 +479 2 9.965 5.93538 15.1079 4.49059 -29.2435 15.7374 +480 2 10.0131 6.81015 13.8895 1.7202 7.35701 -8.16934 +481 1 15.2073 4.3815 10.7753 5.02149 -7.87008 -1.3136 +482 2 16.102 4.07091 10.8622 12.544 -14.2164 -8.54624 +483 2 15.2461 5.11302 11.375 -14.5847 15.9831 9.57625 +484 1 11.1932 6.12384 0.161263 5.03411 2.82645 3.69768 +485 2 11.3288 5.17786 0.364595 -11.2178 11.9329 -9.49937 +486 2 10.2678 6.33084 18.566 9.25768 -12.2342 6.14633 +487 1 0.186838 11.3278 15.1363 -29.5173 30.1692 -23.1318 +488 2 18.3705 11.8565 14.4078 15.8912 -24.6881 20.4884 +489 2 18.5399 11.8236 15.9183 6.48048 -3.45982 -2.85079 +490 1 7.07004 9.14522 7.26474 -13.1186 -12.9635 8.90657 +491 2 6.53932 8.3872 7.60207 7.2147 19.6305 -8.47997 +492 2 7.95552 8.78183 7.22801 5.51641 0.721385 -0.901037 +493 1 18.4462 15.4465 12.3531 0.397712 -4.42488 4.01328 +494 2 0.764911 15.5581 12.2944 -10.8471 -1.16552 -3.91149 +495 2 18.1036 15.6779 11.4829 2.90793 1.2817 1.1609 +496 1 16.5729 4.36464 5.24677 -25.0478 -7.96005 29.4563 +497 2 16.6771 3.95228 6.15287 5.89012 16.1194 -31.2199 +498 2 17.3789 4.38374 4.73556 17.0857 -2.87844 2.77648 +499 1 17.7776 3.07164 10.7152 20.2072 1.91324 7.6701 +500 2 0.0768882 3.1314 10.9751 -16.1773 7.43675 -1.86825 +501 2 17.7244 2.20926 10.3009 -7.90603 -5.17093 -4.6179 +502 1 12.3097 0.0632784 10.17 -5.23585 14.9609 -0.662134 +503 2 11.3669 0.329281 10.3192 28.4735 0.874848 -0.34084 +504 2 12.8997 0.858518 10.2668 -24.0851 -21.9241 -3.33166 +505 1 10.3626 9.82488 12.3121 10.8795 10.4681 17.7395 +506 2 11.1241 9.87716 12.9295 -11.9387 -4.40292 -9.54779 +507 2 10.179 8.8911 12.2253 1.1465 -9.5921 -0.185536 +508 1 0.479623 2.83009 7.02164 2.3472 21.5918 -9.19818 +509 2 0.779466 3.61946 7.51564 -3.03286 -18.4976 -0.625243 +510 2 0.704445 2.06385 7.54355 5.66126 -3.27927 9.79357 +511 1 0.467007 15.244 6.91284 -2.81724 -38.2268 -9.44322 +512 2 0.589986 15.6097 7.78713 1.11258 -6.7374 10.833 +513 2 0.615386 14.2454 7.00377 -3.57496 47.8567 -6.78063 +514 1 16.9531 7.01102 15.3314 25.0955 -6.26352 -3.35293 +515 2 17.7312 7.54015 15.1398 -4.24099 15.1997 -5.49373 +516 2 17.3882 6.19624 15.5982 -13.584 -8.29127 -0.013797 +517 1 9.00968 12.4205 8.1448 -47.4595 3.97518 -14.6445 +518 2 9.255 11.8265 7.44329 24.3825 -11.7648 -7.05727 +519 2 8.04408 12.5071 7.93332 27.0995 7.32888 21.0703 +520 1 1.26609 1.94093 3.05591 2.05426 9.79258 -12.831 +521 2 1.21698 2.59367 2.33971 -7.6512 -12.9321 3.35408 +522 2 1.90984 2.32941 3.65026 1.81811 -2.05605 5.16186 +523 1 4.13335 15.1162 9.63732 -3.37236 0.94273 -0.929026 +524 2 4.11982 15.1465 8.67375 -6.81504 5.04573 1.04836 +525 2 4.9784 14.712 9.81623 8.98269 -4.0071 9.77097 +526 1 7.18021 2.17978 14.5671 7.55504 9.68183 9.47496 +527 2 6.93575 1.71258 13.7681 -0.50379 0.233559 -6.02908 +528 2 7.66352 2.97784 14.2972 -3.4628 -8.48803 0.116771 +529 1 18.6085 14.7119 2.15295 17.2538 -25.5542 -3.98016 +530 2 0.854482 15.0949 2.23403 -8.04084 1.8593 -0.311551 +531 2 17.9464 15.3611 2.33256 -11.9957 20.7574 3.41759 +532 1 9.94838 2.78838 12.9451 -1.38176 -12.4025 -13.9087 +533 2 9.76343 2.19068 12.1969 8.49761 3.03822 8.73498 +534 2 9.19943 3.38599 12.9407 -2.82035 8.06337 4.45668 +535 1 2.81023 8.91387 13.015 -11.0947 -9.09099 -1.03322 +536 2 3.12702 9.79437 12.8576 7.30933 17.7942 -2.89213 +537 2 3.52626 8.44288 13.432 10.5553 -8.83156 6.15268 +538 1 3.22981 8.35572 3.63929 7.91603 12.3414 59.3292 +539 2 3.55022 9.08279 3.12704 6.39159 12.4302 -19.4578 +540 2 3.47038 8.64809 4.58003 -14.7797 -20.4427 -37.089 +541 1 5.63158 7.19787 8.5111 -16.5836 -10.0318 8.45115 +542 2 5.49703 6.26423 8.32413 12.2862 -3.4998 -5.25722 +543 2 4.92977 7.35667 9.15199 5.58983 12.4707 2.72685 +544 1 14.8806 1.27947 2.01044 -5.20911 -29.6221 -13.7523 +545 2 14.8531 1.98102 2.64457 3.54145 24.2946 3.1913 +546 2 15.2413 1.51873 1.14568 -0.321243 12.6895 5.96264 +547 1 8.23741 15.1928 0.849855 10.5438 9.56485 -11.8122 +548 2 9.03414 15.1092 1.40038 -9.07879 -4.36113 3.60062 +549 2 7.50349 14.6875 1.21874 4.98636 -2.78068 7.26539 +550 1 15.6325 1.34538 7.23629 -19.2726 -10.6819 -7.69516 +551 2 14.9548 0.715658 6.87861 16.0521 20.279 9.35294 +552 2 15.1584 2.15623 7.4957 0.78871 -9.00488 -4.70177 +553 1 4.90948 13.0908 18.526 11.7484 -4.19917 14.2638 +554 2 5.32661 13.1046 0.771936 -5.81675 2.26251 -17.1314 +555 2 5.47193 13.6353 17.9612 2.08739 -3.03703 1.40027 +556 1 15.3444 8.47528 18.1477 10.5782 11.2904 -17.9652 +557 2 15.7712 9.10441 17.5134 -10.1785 -13.1115 16.9911 +558 2 15.2549 8.94211 0.342082 0.277618 5.95495 -1.45242 +559 1 12.072 3.0348 18.3713 9.16845 -16.043 3.97866 +560 2 11.9997 2.53228 0.532204 -11.5106 10.3924 18.501 +561 2 12.5782 2.36842 17.9104 5.62845 7.32417 -26.0863 +562 1 13.2089 12.6783 5.18015 6.63876 -6.29032 2.85699 +563 2 13.7391 11.9795 4.78379 -2.73226 -0.00342211 -8.22979 +564 2 13.3831 12.5487 6.11225 -3.40081 8.86391 8.40941 +565 1 6.04915 7.04527 0.0350485 10.8742 -21.2203 -4.52865 +566 2 6.02805 7.99092 18.6226 -5.46576 23.9499 6.727 +567 2 5.33859 6.76219 0.618839 -5.51003 3.35157 1.33709 +568 1 17.7393 16.0214 15.0094 13.9302 -13.9422 41.059 +569 2 16.9573 16.5339 15.2303 -2.65419 1.12677 -17.6965 +570 2 17.9199 15.9264 14.0844 -11.8828 6.17072 -25.9912 +571 1 13.1897 1.00209 16.5482 9.0285 -11.9403 8.82412 +572 2 14.1531 0.926941 16.6936 -12.5978 2.36886 -2.70952 +573 2 12.8801 0.0805392 16.5939 -0.793518 8.62378 -3.88342 +574 1 11.1147 14.5676 7.20714 13.0879 22.2032 -16.1382 +575 2 10.392 14.3041 7.74555 -20.7251 -13.6554 17.189 +576 2 11.8256 13.9392 7.33494 4.5733 -4.90634 5.95678 +577 1 17.5119 8.63301 2.08454 0.0660302 9.5119 10.6671 +578 2 16.6736 8.51459 2.527 -7.33525 3.37542 8.64387 +579 2 17.5132 7.89769 1.49414 7.23803 -17.2019 -20.825 +580 1 12.3543 7.99739 2.01665 -2.5776 9.38468 -13.8973 +581 2 12.1955 8.87571 1.62365 2.26325 -8.37679 12.9533 +582 2 11.9634 7.39841 1.37453 -1.21895 -7.08079 -1.91625 +583 1 11.8862 14.6191 10.3431 -20.5633 -33.2885 -21.2052 +584 2 12.048 13.7971 9.8109 4.18347 28.6601 18.3667 +585 2 10.9021 14.6739 10.3387 21.4811 7.86907 3.51893 +586 1 6.88785 7.04202 15.6064 18.5625 21.2571 16.3476 +587 2 7.79496 7.28653 15.325 -16.282 -10.9681 -3.58347 +588 2 6.76913 7.58838 16.4136 -4.66142 -14.4555 -17.927 +589 1 8.00173 4.72633 13.4744 30.8534 11.0647 12.2619 +590 2 7.23536 4.76996 12.9314 -21.7993 1.23146 -17.3356 +591 2 8.43981 5.59806 13.3773 -8.25054 -18.6352 3.63378 +592 1 13.408 12.1818 14.2607 -3.38159 -13.7589 -5.77775 +593 2 13.0599 11.273 14.209 4.17969 5.9499 4.9999 +594 2 13.8015 12.3234 13.3884 0.552928 6.09909 4.73433 +595 1 14.8332 9.42219 7.30259 -3.18701 -8.441 -7.55641 +596 2 15.6639 9.86655 7.42287 15.173 5.4083 -0.0492361 +597 2 14.1987 10.0431 7.62107 -17.8235 6.30723 6.71627 +598 1 12.6528 17.0596 3.07812 -8.70602 18.4808 5.33985 +599 2 12.9496 17.4673 3.92869 -9.46791 -7.74089 -22.4319 +600 2 12.0101 17.6853 2.63014 23.5323 -19.7514 22.4129 +601 1 1.16198 7.14088 17.4585 -7.06812 8.47411 -13.2553 +602 2 0.305081 7.19087 17.9183 5.00325 -4.47293 -7.14563 +603 2 1.04973 7.54449 16.5661 0.440843 -6.25707 18.2149 +604 1 12.7703 5.1502 15.6519 20.537 -9.206 9.03076 +605 2 13.4569 4.49661 15.9358 -13.2491 19.9411 -11.3493 +606 2 13.2029 6.02791 15.5919 -0.675517 -15.6076 2.74775 +607 1 2.52973 3.39372 4.98628 -12.5021 24.9114 40.8727 +608 2 1.78336 3.12225 5.60975 27.8197 11.256 -19.0698 +609 2 2.94772 4.23746 5.36491 -19.3389 -38.1774 -13.5008 +610 1 8.3189 11.2987 13.4496 33.0028 -42.3062 59.2485 +611 2 8.52043 10.9592 14.374 -32.1909 27.8732 -26.3694 +612 2 9.06111 10.8351 13.0577 -1.72326 7.29715 -30.1092 +613 1 12.8789 1.33643 13.3362 0.40834 22.0058 -3.21803 +614 2 13.4118 1.44301 12.5159 -13.2456 3.30889 14.5055 +615 2 12.3632 2.16071 13.5095 17.0122 -18.2145 -15.4576 +616 1 6.34323 13.7037 2.15004 -8.90275 3.4942 1.01633 +617 2 5.67068 13.9831 2.80896 17.8093 -8.54249 -8.97759 +618 2 6.94017 13.0667 2.55763 -1.44693 0.407866 6.84109 +619 1 15.9207 6.60938 12.7941 -14.0219 -16.6873 -1.46208 +620 2 16.3665 7.21966 12.2297 10.4548 13.0291 -14.3606 +621 2 16.4032 6.61209 13.6164 4.57404 0.312906 11.3916 +622 1 16.837 0.713429 9.59537 -4.60186 -23.2491 -5.40047 +623 2 16.7766 18.3812 9.76009 1.861 23.059 -1.51736 +624 2 16.4539 0.846132 8.70764 2.52408 0.807103 8.64662 +625 1 6.14677 11.7538 8.37929 1.46343 -38.2042 -1.58984 +626 2 5.28119 11.5099 8.79312 19.6536 2.3972 -11.55 +627 2 6.62627 10.8955 8.13754 -23.51 30.7545 10.2414 +628 1 2.89887 8.61954 0.44521 -58.0253 1.44029 -30.8084 +629 2 2.28026 8.19904 18.4406 35.2092 -5.33136 7.34884 +630 2 2.23436 9.22701 0.790296 19.604 11.6332 17.9417 +631 1 10.1646 10.4607 6.5042 -2.67562 1.82661 -6.4385 +632 2 10.6119 9.73033 6.95167 0.990091 1.19991 -1.59039 +633 2 10.4858 10.4732 5.58284 -1.09389 -1.85789 13.424 +634 1 6.73063 15.6946 6.55447 -0.851851 -4.83477 5.20485 +635 2 7.09829 16.1491 7.32752 1.36873 0.436433 -10.1699 +636 2 7.02842 16.1335 5.74515 1.47904 6.69628 7.42626 +637 1 6.44804 13.1708 5.58287 -3.43311 -13.1021 10.8705 +638 2 6.66139 13.9646 6.07673 2.2473 5.97996 0.728386 +639 2 6.06157 12.5687 6.2363 0.868112 2.44944 -5.20285 +640 1 16.8203 12.5595 9.83963 -1.29973 -13.3798 -26.0882 +641 2 16.9797 11.9255 9.1094 -0.187484 2.38257 16.1818 +642 2 16.6351 13.3676 9.36293 0.809528 9.54538 5.72824 +643 1 6.04152 2.95052 2.84999 -1.13024 -25.4835 15.2707 +644 2 6.4006 3.79327 2.62573 5.01416 22.8678 -12.9444 +645 2 5.58314 2.5656 2.09763 0.434854 2.67004 -8.58918 +646 1 10.9107 3.32852 3.29939 -12.4238 -2.51051 -2.149 +647 2 10.2568 3.99067 3.55961 5.98057 0.0707186 3.553 +648 2 10.4887 2.88551 2.55708 3.841 -3.98893 -4.96007 +ITEM: TIMESTEP +20 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.69334 7.07477 17.9589 0.0661907 -8.15672 -5.93801 +2 2 7.76544 6.892 18.1438 2.06168 0.344835 4.67083 +3 2 8.87494 6.58302 17.1494 0.0923072 2.18051 2.08263 +4 1 18.5724 8.27759 6.8487 9.68108 -9.0135 5.9796 +5 2 0.0748736 7.96696 5.95521 0.0469709 2.78304 -15.7461 +6 2 0.399795 7.62446 7.38749 -2.21574 6.41883 6.02377 +7 1 8.4 18.5641 6.8134 3.87483 8.82198 -0.0595031 +8 2 9.32611 0.166963 6.70047 -3.24105 -1.28376 -0.166563 +9 2 7.89494 0.641414 6.41149 2.5055 -2.76566 0.153015 +10 1 6.59225 1.83896 11.6912 -0.275689 0.302437 5.80014 +11 2 5.92509 2.27303 12.2308 -4.07131 5.9643 -4.10931 +12 2 6.1821 1.00166 11.4658 -1.55571 -7.95905 -4.17259 +13 1 7.1255 5.73378 2.34451 -23.1841 27.0209 10.5427 +14 2 6.64356 6.29382 2.99422 10.5833 -21.9235 -2.45439 +15 2 6.93596 6.23963 1.54379 8.61204 -12.4491 -6.79559 +16 1 16.2118 10.162 16.1238 9.73263 11.3036 -6.58381 +17 2 17.0956 10.2901 15.7587 -2.05967 -6.96031 3.12171 +18 2 15.9212 11.066 16.279 -7.86411 -1.51367 3.55804 +19 1 10.6155 15.0016 2.3147 2.6864 2.11515 1.56294 +20 2 10.6002 14.5314 3.15674 -2.41534 -3.03603 0.679536 +21 2 11.0785 15.8209 2.51731 -0.0195897 0.981381 0.0978469 +22 1 17.1585 8.25197 10.4305 1.44624 0.93325 5.78222 +23 2 16.6499 8.94547 10.8694 -0.557047 -3.86734 3.9084 +24 2 18.0092 8.65295 10.2197 -0.225121 0.250414 -1.13708 +25 1 14.8741 15.8852 16.3481 -7.08493 -6.82471 0.413246 +26 2 13.9679 16.1979 16.3007 -7.09092 5.8218 -2.34027 +27 2 14.8494 15.2418 17.0641 6.82868 3.48864 5.90805 +28 1 12.1588 13.3817 0.433178 -6.27467 12.7595 -4.80914 +29 2 12.0352 13.6324 18.1551 4.79076 -7.76922 -3.88045 +30 2 11.6846 14.0735 0.910169 -3.08866 -6.36125 10.7585 +31 1 9.27449 5.40778 4.04397 -13.9365 -16.0184 3.55858 +32 2 8.80012 5.02015 4.81047 7.30704 13.9384 -9.37026 +33 2 8.62496 5.33174 3.3181 9.32114 8.483 4.67507 +34 1 1.82732 4.26294 11.6464 -4.04254 -2.69427 0.93532 +35 2 1.77693 5.20244 11.8864 -0.000737327 -7.07977 -0.141665 +36 2 2.24287 3.78422 12.3753 -0.858945 2.71416 -2.4423 +37 1 1.98268 6.82933 8.36887 -4.76513 2.22844 -15.7156 +38 2 2.36253 7.23451 9.15103 4.34961 -4.46197 5.21996 +39 2 2.01952 5.87123 8.47722 1.07428 0.125821 9.68028 +40 1 5.39566 4.39684 7.93565 8.0799 8.40992 8.79829 +41 2 5.46014 3.43633 8.01893 -3.87159 0.552259 -10.4859 +42 2 4.76986 4.63893 7.2446 -2.8004 -4.28351 -0.196723 +43 1 3.26324 2.92599 17.538 -6.48526 11.4036 5.90093 +44 2 3.9521 3.41084 17.0519 -4.33162 -2.5567 2.49087 +45 2 2.74469 3.58038 18.0606 14.1441 -6.64194 -12.4081 +46 1 7.47828 5.27232 6.10849 -6.04695 1.38866 -9.34596 +47 2 7.88111 5.94624 6.68322 -4.96979 -11.9122 3.47667 +48 2 6.82246 4.73008 6.58045 9.57964 11.031 7.72945 +49 1 9.77144 7.02208 11.9904 4.73189 -1.1383 -1.06285 +50 2 10.3467 6.38126 11.5734 3.30689 -2.46386 0.831607 +51 2 9.14216 7.24941 11.3005 -7.52384 3.80108 0.31383 +52 1 14.0798 3.55416 8.05513 -3.28328 4.35009 -1.93857 +53 2 13.7004 4.26501 7.52877 0.673114 -0.544944 -0.0617854 +54 2 14.5392 3.99696 8.77439 -0.252332 -0.945414 2.55344 +55 1 4.73763 17.2389 4.01031 -0.321378 8.61877 -17.0141 +56 2 5.59566 17.6635 4.11691 -0.835388 -5.76098 7.55997 +57 2 4.38449 17.6475 3.19969 -7.45685 -7.93836 11.3283 +58 1 16.5107 16.6056 10.0759 6.54448 8.81329 9.76337 +59 2 15.9397 16.7408 10.8388 -5.01232 -5.78767 -1.53078 +60 2 15.9723 16.2069 9.3894 -4.78788 -4.31379 0.495659 +61 1 1.96746 4.90416 0.450775 -1.81832 7.5424 0.20662 +62 2 2.57813 5.33173 1.07474 -1.76589 -7.7088 -3.71938 +63 2 1.58349 5.65244 18.6136 5.80255 -6.17515 -0.843526 +64 1 11.7761 13.343 16.2841 -6.04701 8.80367 11.8739 +65 2 11.2992 12.5177 16.4849 4.5736 1.77316 -11.3497 +66 2 12.2862 13.2596 15.4658 -7.12668 -12.5479 1.29578 +67 1 10.1128 11.0591 16.9331 1.69597 -16.074 1.546 +68 2 10.529 10.1874 17.0807 -3.30995 11.3925 -3.21813 +69 2 9.18388 10.849 16.7697 3.68635 3.27029 -1.84825 +70 1 11.7127 17.5197 13.4648 11.3019 2.11475 -5.22831 +71 2 12.331 17.0869 12.8651 -0.203424 -4.77186 2.96515 +72 2 11.9976 18.4453 13.422 -5.71015 -0.897636 4.76739 +73 1 6.35333 9.30557 12.2266 11.9787 8.60001 -4.91149 +74 2 6.91868 9.08658 11.4768 -7.06745 -10.6307 -2.02859 +75 2 6.87303 9.9972 12.642 -2.68502 3.03115 9.09234 +76 1 16.2229 12.7446 2.69624 -0.291567 -17.1772 2.14859 +77 2 17.0444 13.127 2.38556 1.82795 9.93981 0.639945 +78 2 15.5737 13.4355 2.84522 -0.398116 10.9003 -3.52894 +79 1 0.630414 12.571 5.87324 -2.78001 5.23525 -2.09291 +80 2 1.00794 12.4159 4.99822 -5.49855 2.79722 0.151968 +81 2 18.3568 12.8603 5.70082 10.405 -7.04854 2.54099 +82 1 5.20787 16.4001 18.4776 -12.5497 0.602195 -7.10426 +83 2 5.86464 15.8156 18.076 4.18722 4.70251 6.39081 +84 2 5.5918 16.9091 0.552483 9.38889 -4.76533 -0.723228 +85 1 0.52849 7.63403 4.08589 29.1287 17.8407 -12.6947 +86 2 18.5836 7.90722 3.36083 3.6478 2.13346 8.06342 +87 2 1.42012 8.03877 3.86645 -30.4536 -16.431 6.17599 +88 1 3.1381 8.91119 6.51072 -13.5755 -1.26875 13.9192 +89 2 3.59199 8.61596 7.312 -0.196935 0.713487 -8.34602 +90 2 2.19086 8.84537 6.73861 12.9731 1.00292 -6.41375 +91 1 7.31254 10.3111 16.1924 3.71601 3.69021 9.41051 +92 2 6.5835 10.5117 15.6001 -2.45726 -1.05124 6.16708 +93 2 6.97924 10.3433 17.1122 -4.5268 -1.10556 -13.1914 +94 1 11.1003 1.05051 4.99797 5.80988 -5.62906 14.1745 +95 2 11.3837 1.86623 4.56736 -9.38615 -1.44268 -8.87945 +96 2 10.7526 0.427875 4.34338 1.37635 7.2616 -4.61902 +97 1 4.41216 2.72626 13.196 4.39031 -15.812 27.2385 +98 2 4.68873 3.14242 14.0209 1.29771 13.5884 -6.24163 +99 2 4.35373 1.80262 13.5146 -5.93981 4.62314 -19.463 +100 1 8.39633 10.0477 1.8021 8.65231 5.58991 3.9521 +101 2 8.43584 10.7505 2.47552 -3.18527 -5.8592 -1.95349 +102 2 8.78245 9.25294 2.20632 -6.17245 6.11296 -0.869653 +103 1 10.5167 1.74791 15.5607 -12.987 -0.969766 6.95693 +104 2 11.4294 1.4693 15.6846 2.64548 4.13814 -6.20872 +105 2 10.3497 1.97094 14.6365 5.88046 -1.13362 -2.56443 +106 1 2.75172 12.9341 7.77038 -1.98364 -2.25212 -7.11701 +107 2 3.34024 13.5411 7.30753 1.72417 1.81116 5.40918 +108 2 2.20386 12.578 7.06153 -5.53374 1.90184 4.06344 +109 1 3.65904 11.6762 5.27167 1.4745 3.00351 -5.43274 +110 2 3.4246 11.0613 5.97769 -1.9036 -0.651658 -6.95213 +111 2 2.87422 11.8691 4.73548 4.37313 -4.77202 2.40024 +112 1 6.8497 14.4837 16.8623 -7.20011 -2.9268 7.54224 +113 2 7.64382 13.9472 16.8068 -1.68272 1.48794 -3.62778 +114 2 6.45279 14.5388 15.9848 5.36951 2.03983 -1.60361 +115 1 14.1732 14.5515 3.40534 8.00808 -4.71428 -5.83886 +116 2 13.686 15.3662 3.26714 -6.11485 0.946493 -0.0166146 +117 2 13.6673 13.9759 3.98664 -1.2314 3.40033 5.39954 +118 1 8.29912 18.1674 16.0589 -20.5282 -4.34905 -0.197762 +119 2 8.7408 17.3576 16.3653 13.9085 14.9544 -3.06277 +120 2 8.83266 0.312858 15.8727 12.6636 -13.3116 3.05514 +121 1 4.73053 1.62244 4.91728 3.73461 17.8941 -9.82498 +122 2 3.87083 2.07692 4.90413 8.70323 -5.84393 3.64668 +123 2 5.31846 2.19299 4.38363 -11.3635 -9.88313 3.69576 +124 1 15.0998 12.7921 16.4359 -16.5392 5.6559 5.83964 +125 2 14.613 13.1569 17.1797 9.93151 -3.40376 10.0434 +126 2 14.4182 12.7815 15.762 4.3611 -9.31248 -14.0367 +127 1 15.7898 18.3971 16.8042 5.79346 -1.22695 27.8179 +128 2 16.3329 18.5498 17.6117 -9.65553 4.21222 -20.1346 +129 2 15.4648 17.4968 16.9407 3.00983 3.14177 -9.23088 +130 1 1.14588 1.15091 16.5513 6.84042 -4.63386 -6.55399 +131 2 1.94328 1.67743 16.706 -5.62204 0.173811 5.06431 +132 2 0.528577 1.37004 17.2554 5.0728 5.5861 0.922174 +133 1 18.0913 4.5707 15.884 4.25376 -5.47852 -1.15194 +134 2 18.5654 4.01411 15.2573 -2.45188 0.25544 1.09753 +135 2 18.6545 4.64521 16.6589 -1.38654 0.113736 -2.45626 +136 1 12.2253 16.9711 16.1412 0.914186 -11.4555 3.91466 +137 2 11.5632 16.3741 16.5429 5.70701 14.4982 -7.43821 +138 2 12.0767 16.9746 15.1851 -6.52552 1.11271 2.73005 +139 1 15.9091 2.53324 17.9911 -0.813861 17.5084 -1.21546 +140 2 15.6764 3.36649 18.4268 1.17892 -6.2644 3.50604 +141 2 15.6868 2.72575 17.0644 4.5424 -10.5093 4.50867 +142 1 6.70264 13.8034 10.241 3.67042 13.5267 -3.47207 +143 2 6.65382 13.63 11.1889 -2.71481 -10.4168 -1.32753 +144 2 6.64075 12.981 9.74212 -1.13183 -3.39045 4.84834 +145 1 10.1303 18.2368 2.79334 3.88934 4.25391 -9.05815 +146 2 10.3528 0.228802 2.09034 -3.74927 -2.61302 6.3793 +147 2 9.24556 17.9143 2.58077 2.23777 4.46644 1.38681 +148 1 2.97822 17.7592 6.09436 6.84514 -11.0569 -16.6755 +149 2 2.2147 17.6257 5.53291 -18.2595 3.26089 9.16469 +150 2 3.66284 17.6557 5.427 11.9633 8.77303 4.67614 +151 1 12.5626 16.9639 7.98676 12.5848 -1.11028 -8.52053 +152 2 11.8839 16.2724 7.94525 -2.9484 9.81966 4.92503 +153 2 12.3706 17.6612 8.63222 -7.85492 -11.7975 4.91014 +154 1 14.885 15.2749 8.26678 1.09184 -13.1129 19.8008 +155 2 14.1202 15.8628 8.27106 1.10724 6.83397 -10.769 +156 2 15.4286 15.3633 7.48102 -5.52588 8.50153 -14.3957 +157 1 17.5862 18.2834 0.376986 -24.9344 -1.23553 -1.17468 +158 2 18.3469 17.8479 0.005767 18.8411 -2.89863 0.907383 +159 2 17.8259 0.448151 0.831731 10.0339 0.947456 -0.506579 +160 1 0.885899 10.3809 1.40397 7.22911 -11.5028 6.53987 +161 2 0.114071 9.81378 1.55479 0.851643 9.57639 -0.353744 +162 2 0.635753 11.1007 0.824785 -9.84019 7.34982 -5.0696 +163 1 1.59112 12.2023 3.3355 8.42913 -7.93475 21.5428 +164 2 1.38243 11.4488 2.766 -0.926106 10.11 -6.99043 +165 2 1.6499 13.0233 2.84482 -2.64968 -0.879455 -11.853 +166 1 0.551086 17.2511 4.8776 21.276 -3.63263 -24.3978 +167 2 -0.0762795 17.9651 4.97462 -6.3407 4.63135 13.3725 +168 2 0.558623 16.612 5.58807 -10.7338 -2.48853 14.1039 +169 1 1.11389 0.976548 9.40441 -9.70348 2.26791 0.52143 +170 2 1.20067 0.739298 10.3296 11.5619 -5.66825 6.05541 +171 2 0.194683 0.747268 9.24308 -0.993818 -3.51563 -8.196 +172 1 16.7801 2.33697 13.2827 1.26658 -2.58515 -3.42214 +173 2 16.9917 2.52603 12.3542 -2.2694 -1.44301 7.47438 +174 2 16.5315 1.40163 13.3451 -1.6586 3.84983 -3.29893 +175 1 2.50653 15.8317 12.198 6.9942 0.0378495 -5.39106 +176 2 3.03319 15.4932 12.933 -2.33393 0.151651 -5.20129 +177 2 2.92041 15.5438 11.3652 -1.63849 1.19534 6.62391 +178 1 16.4211 15.5676 5.95733 20.9565 28.2944 1.83954 +179 2 17.3426 15.5843 6.27645 -8.81355 -7.9692 1.26231 +180 2 16.3612 16.4166 5.46885 -9.28613 -17.0928 2.60564 +181 1 5.82453 5.03389 11.7824 5.33446 0.320875 1.57619 +182 2 5.57998 5.74431 12.3877 -7.39983 3.16893 -2.12011 +183 2 5.27405 4.27426 12.0034 -1.54313 1.61628 -0.196815 +184 1 15.2115 4.85871 0.718957 -12.3292 -1.21553 20.1953 +185 2 14.9951 4.64926 1.65891 1.99725 2.35951 -19.8125 +186 2 14.3839 5.18637 18.9796 8.05664 -2.8997 2.32554 +187 1 16.3489 16.3233 2.11444 -1.37403 -13.232 -8.15517 +188 2 15.9103 16.7203 2.87049 4.10511 7.42013 3.0617 +189 2 16.5474 17.0218 1.48672 0.743353 6.63736 2.3016 +190 1 0.282027 4.87119 3.80055 19.2835 17.3487 3.53091 +191 2 0.489613 5.83173 3.76503 -11.8967 -17.4303 3.14809 +192 2 1.11089 4.48306 4.11838 -9.18259 -2.61174 -2.176 +193 1 2.9303 15.0125 15.0392 0.0573492 -0.181072 31.7668 +194 2 2.82615 14.584 15.9186 6.41531 2.15453 -14.4377 +195 2 2.5906 15.8967 15.228 -6.81336 0.182398 -11.4579 +196 1 1.12223 14.6049 9.5632 13.1187 -18.7351 -0.898815 +197 2 1.97867 14.3698 9.19328 2.71847 14.7063 -6.21023 +198 2 0.940175 13.7592 9.98602 -14.9991 7.00648 6.43026 +199 1 13.665 16.6454 11.5316 -21.8339 3.0331 3.55613 +200 2 13.1746 17.4327 11.223 10.4467 -7.06131 -5.36321 +201 2 13.1002 15.9021 11.2581 8.49503 1.30575 -4.9094 +202 1 4.71709 1.47693 0.719081 -0.792104 -2.26487 7.67979 +203 2 4.13723 2.08795 0.242023 0.0358417 -6.61504 -0.0652634 +204 2 4.16248 0.903426 1.27536 -1.89276 3.42768 -9.42283 +205 1 1.43372 18.4947 11.8904 0.435024 0.903574 -5.06079 +206 2 1.25876 0.369488 12.6813 0.171373 0.403899 4.07674 +207 2 1.76959 17.6363 12.1756 0.0129122 3.12302 0.145238 +208 1 11.5344 10.1145 4.09755 11.0508 4.0163 -22.2825 +209 2 11.4066 10.5292 3.21014 2.38528 -6.34716 18.1192 +210 2 12.5036 10.0411 4.22804 -15.2135 3.993 -1.98571 +211 1 8.36281 12.1777 3.74701 -13.1943 -6.81146 -12.1909 +212 2 9.18722 12.6378 3.9579 -8.09176 1.3179 12.2751 +213 2 7.70079 12.2682 4.46238 18.0882 5.10492 -3.45512 +214 1 14.3344 4.02288 3.28855 15.2498 3.93213 6.6836 +215 2 15.0617 4.23514 3.91062 -12.0049 -4.72392 -3.76747 +216 2 13.5379 4.47251 3.60621 4.75183 0.0120405 -3.02562 +217 1 5.58434 1.74596 7.50985 -22.3692 -26.8297 9.12948 +218 2 4.91823 1.11394 7.92632 27.2868 23.8434 -15.8784 +219 2 5.43743 1.67946 6.54893 -3.28939 1.24453 9.56906 +220 1 17.9012 1.11073 4.88195 -3.31078 -7.47428 -4.80941 +221 2 18.5525 1.45486 4.25184 -3.70144 3.91348 6.86656 +222 2 17.7599 1.74881 5.59037 4.24211 2.13046 -3.7457 +223 1 6.8304 9.4053 4.48372 -13.6803 0.789023 -7.06041 +224 2 6.74666 9.48009 5.43928 9.48337 1.88908 4.46236 +225 2 7.74899 9.21301 4.27057 2.55497 -2.6247 5.048 +226 1 2.68932 14.9418 1.9668 -6.12139 1.43036 2.89635 +227 2 3.30587 14.7185 2.6759 1.77318 0.618157 -6.66396 +228 2 3.15681 14.9246 1.12432 2.70839 -4.47578 5.21755 +229 1 17.2859 12.889 13.1454 -5.46423 18.1991 -4.92566 +230 2 16.4361 13.3067 13.278 -15.9577 -14.9195 9.16742 +231 2 17.7285 13.6846 12.8505 24.3586 -1.49654 -2.29875 +232 1 15.0069 10.5712 1.38624 -2.11062 -3.1818 -0.491761 +233 2 15.5786 11.255 1.74854 2.03128 0.359313 2.4477 +234 2 14.2323 11.0405 1.08579 -5.34855 2.20107 -0.889893 +235 1 5.70672 6.90314 4.53443 4.24519 -5.28557 8.89432 +236 2 5.96576 7.83558 4.52332 0.860976 -3.32444 -1.54743 +237 2 6.34045 6.45199 5.11743 -0.773999 0.740319 -5.54545 +238 1 8.07933 8.28074 10.2171 -3.64639 -3.67369 23.1077 +239 2 8.76707 8.87858 9.90894 -2.7343 3.77639 -10.7375 +240 2 7.6749 7.81667 9.48055 2.86655 5.40525 -7.79011 +241 1 13.5084 18.3075 5.79227 -0.609935 12.5659 -0.945985 +242 2 12.8781 0.387145 5.63591 -2.7451 -9.905 0.332396 +243 2 13.1846 17.8335 6.57076 -1.7745 -1.29433 -5.46225 +244 1 0.277736 2.58212 0.118598 0.621477 -2.00702 8.56184 +245 2 17.957 2.7127 18.6839 10.2871 11.0559 -0.501636 +246 2 0.794319 3.38844 0.33639 -19.4232 -4.52538 -3.88061 +247 1 12.6801 10.9983 9.7602 -12.9965 -11.6862 -0.561246 +248 2 11.7228 10.8953 9.6485 6.19444 12.5166 -3.56604 +249 2 12.897 10.0826 9.9647 14.0656 0.707903 4.64438 +250 1 0.781933 12.2574 11.0872 -6.04901 -2.18816 6.07288 +251 2 18.4712 12.3682 11.1342 -4.62852 -2.97634 -7.25325 +252 2 1.06266 12.4852 11.9795 7.76729 1.60409 -2.26455 +253 1 5.05561 7.24886 13.466 -11.4852 -6.03635 -4.86876 +254 2 5.50236 8.03712 13.1394 10.7241 -0.576345 -1.34855 +255 2 5.49314 6.97472 14.2774 5.89817 7.37955 3.96262 +256 1 1.26581 6.94402 11.8396 4.62667 -0.613543 7.50244 +257 2 0.504801 7.20295 11.3208 -2.84364 2.86798 -1.49635 +258 2 1.66495 7.76854 12.1529 -2.34869 -3.61795 -5.23307 +259 1 15.4733 9.48228 12.3076 -4.70583 25.6475 16.0975 +260 2 15.3149 10.4406 12.4106 2.52372 -12.0579 -11.0564 +261 2 15.3983 9.16189 13.2139 2.67764 -6.7615 -6.72177 +262 1 16.6336 12.9201 5.4628 6.66579 -20.8603 16.0577 +263 2 16.5173 13.872 5.54201 -7.55482 0.841067 -13.5204 +264 2 16.4587 12.5944 4.56908 -1.3904 13.4091 -1.6671 +265 1 6.18458 10.0203 0.145227 10.7922 -3.52818 2.39688 +266 2 5.51531 10.431 0.700604 -4.05423 0.759005 -2.7608 +267 2 6.99302 10.1148 0.667984 -1.67417 -4.19008 -1.28624 +268 1 12.3589 6.06668 4.038 0.452115 -1.15559 12.336 +269 2 12.2616 6.902 3.56852 -2.7325 -0.676505 -9.18667 +270 2 11.4806 5.67315 4.10483 0.607886 2.8799 -4.57435 +271 1 0.151536 12.8218 0.203335 4.13456 -2.94622 -2.33064 +272 2 -0.0129983 13.5003 0.871422 4.06521 1.52419 -2.90371 +273 2 18.34 13.1254 18.0507 -1.07008 -0.669132 2.22617 +274 1 3.8124 18.585 8.59267 3.71655 -0.510361 5.11861 +275 2 3.56708 18.0759 7.80793 -6.58546 5.02297 1.51156 +276 2 3.01311 0.371537 8.92178 -4.29721 -3.94788 -5.16471 +277 1 7.41673 17.2735 4.46563 5.27699 16.8729 -12.8498 +278 2 7.96434 18.0381 4.66458 -2.5447 -1.66977 13.1327 +279 2 7.34622 17.3735 3.5102 -3.86431 -11.0257 -0.167405 +280 1 9.22722 17.0589 12.2393 19.2623 -14.5641 0.108859 +281 2 9.27149 16.2912 11.647 -4.87121 6.1965 2.03703 +282 2 10.0709 17.0037 12.729 -13.5572 10.6592 -2.64279 +283 1 13.3059 12.9585 7.95053 -5.93488 5.61094 -2.56551 +284 2 13.3162 12.2379 8.59837 1.79032 5.44422 0.740585 +285 2 13.8923 13.6822 8.21069 6.53108 -7.176 5.15054 +286 1 14.9676 2.9565 15.3436 -0.386658 0.574387 3.68052 +287 2 14.4202 2.18777 15.1252 1.77471 7.19316 -4.43588 +288 2 15.6633 3.03092 14.6718 -7.27619 -4.52831 0.823712 +289 1 9.86266 15.5244 17.0043 3.51131 -4.56125 -2.22878 +290 2 10.4016 14.759 16.7592 -3.4195 -0.793849 -1.98877 +291 2 9.23782 15.2217 17.674 1.65588 4.18023 5.21634 +292 1 11.2982 8.26605 16.5436 5.00814 15.3472 3.18516 +293 2 10.6561 7.79454 16.0057 0.999826 -4.04983 -0.0472571 +294 2 11.6606 7.65108 17.1873 -4.09078 -4.29715 -0.00155616 +295 1 3.81225 18.1964 16.7292 10.4788 2.16731 8.30533 +296 2 4.28955 17.5863 17.3008 -0.586781 -10.0924 -3.62086 +297 2 3.8829 0.368785 17.226 -6.17555 6.78007 -4.03101 +298 1 2.19803 4.12169 8.95254 -8.42555 5.0907 -8.8117 +299 2 3.07539 3.82533 8.67919 -2.6088 -0.1453 11.8715 +300 2 2.06404 4.00225 9.90658 13.5851 0.597917 -5.47855 +301 1 9.88178 10.3569 9.73038 4.79618 9.75255 -1.56513 +302 2 9.58096 11.2105 9.34815 0.270313 -13.7408 11.2463 +303 2 10.0884 10.4563 10.6769 -5.68787 3.60286 -6.41077 +304 1 9.72212 0.809424 10.8539 19.6856 13.2875 8.50656 +305 2 9.35568 18.6419 11.2241 -8.56647 -0.801274 -6.22283 +306 2 9.1718 1.19131 10.1642 -10.1616 -7.34852 -1.36201 +307 1 9.20808 15.1775 10.2123 -15.4381 -3.13199 6.73164 +308 2 8.85567 15.9769 9.80113 1.42232 -2.21967 -3.83769 +309 2 8.41617 14.6283 10.3808 11.8702 3.92611 -8.2586 +310 1 0.995689 9.3369 10.3259 -16.0333 -0.722577 -1.64132 +311 2 1.04111 10.3025 10.3672 11.5337 -2.90556 1.12718 +312 2 1.85551 8.94205 10.1494 2.50931 13.4523 1.23502 +313 1 16.8622 4.87275 8.19393 -0.422934 0.254968 7.2846 +314 2 16.1689 5.44633 8.57547 10.3862 -6.79292 -0.962882 +315 2 17.2033 4.29721 8.90095 -5.62498 7.92604 -8.45296 +316 1 14.656 14.7011 0.368319 0.981504 1.6367 -2.03469 +317 2 15.1464 15.0731 1.12238 -4.61865 -0.709772 -8.09446 +318 2 13.8079 14.3976 0.718239 6.88081 -1.79732 0.157513 +319 1 3.54139 11.054 9.61635 4.40574 2.25524 -6.23941 +320 2 3.65641 11.5568 10.4349 -3.33961 -4.79202 -0.629126 +321 2 3.06202 11.6341 9.00365 5.95536 0.511998 4.3162 +322 1 11.0657 10.8474 1.29636 2.92174 -3.12366 4.90686 +323 2 11.2982 11.6263 0.767958 -3.5102 -3.65436 5.75862 +324 2 10.1232 10.6698 1.15822 5.54645 2.63321 -1.67034 +325 1 13.2072 7.07995 12.8701 -0.715054 4.17079 -6.48984 +326 2 14.1512 6.89692 12.9697 -2.29399 1.70307 -2.36257 +327 2 12.7789 6.22148 12.7926 -0.519741 -2.64677 3.01569 +328 1 9.62848 1.89714 0.960589 0.144249 -1.27383 8.14422 +329 2 8.75389 1.7191 0.595255 2.62606 0.878667 -4.42234 +330 2 10.2646 1.96201 0.242782 -4.84565 1.17493 -5.89222 +331 1 10.5889 13.5223 4.7138 2.80012 2.67941 -15.7349 +332 2 11.4734 13.1444 4.59356 -4.0194 -1.02806 11.2737 +333 2 10.6142 14.0248 5.53615 3.92037 -3.05166 -0.671 +334 1 14.2891 1.71547 10.914 14.736 9.54636 -9.28817 +335 2 15.0906 1.40219 10.4788 -2.27816 -10.6125 3.67971 +336 2 14.438 2.66833 10.8812 -8.3278 1.7804 6.62982 +337 1 14.6539 12.3888 11.7057 -9.85382 -5.79197 9.84531 +338 2 15.5174 12.4906 11.2689 -13.4179 -5.72309 -9.10321 +339 2 13.9464 12.0325 11.1297 19.1264 4.07718 -1.67851 +340 1 8.24463 5.07042 9.80489 8.67652 16.3821 0.210642 +341 2 7.41075 5.25266 10.2586 0.116202 -10.888 -2.54867 +342 2 8.19641 4.23298 9.33202 -10.3006 -5.74151 5.58561 +343 1 1.57762 16.8331 18.335 1.68687 -2.26048 -0.033424 +344 2 1.80587 17.1847 17.4697 -0.252498 3.71983 1.68741 +345 2 2.01633 15.9753 18.3429 -7.29056 -3.61139 0.997127 +346 1 1.4432 17.2346 15.332 2.65894 -7.35401 -5.7102 +347 2 1.56202 18.0921 15.7447 -7.04866 6.37518 1.22888 +348 2 0.495246 17.0477 15.225 10.7628 4.03376 7.259 +349 1 3.71499 5.60328 6.17396 -2.46237 18.0728 1.59518 +350 2 3.14409 6.20568 6.67532 2.19379 -7.75625 0.984178 +351 2 4.32024 6.21155 5.72591 -1.08806 -7.05296 -5.84211 +352 1 12.3532 9.43776 14.1893 13.0079 -11.8089 -5.25996 +353 2 12.7562 8.63341 13.7793 -8.52026 15.4152 14.9752 +354 2 12.1872 9.21442 15.1219 0.0848175 -4.0166 -10.4276 +355 1 4.03165 15.279 6.91423 11.4052 5.55751 -7.84178 +356 2 3.54353 15.996 6.48767 -3.99323 -1.71496 7.04649 +357 2 4.96733 15.4866 6.74143 -6.91754 -4.3684 4.91577 +358 1 0.598678 8.56195 14.8837 5.20406 11.6905 0.774862 +359 2 0.593362 9.51845 15.0326 -4.59172 -3.85379 3.33684 +360 2 1.20863 8.47913 14.1435 0.530109 -4.80423 2.60663 +361 1 12.9822 8.33824 10.332 -12.7812 8.13505 -15.7365 +362 2 13.7449 7.91273 9.91994 1.65618 -4.07378 8.99333 +363 2 12.9305 8.07685 11.2552 9.52621 -6.7264 2.9301 +364 1 15.3077 7.66451 3.49902 -16.235 -26.2008 20.478 +365 2 14.5457 7.14577 3.24297 -4.72624 11.0142 -23.2354 +366 2 15.4625 7.21195 4.33822 21.3334 18.0327 3.91528 +367 1 17.3129 6.65992 0.0418436 1.52354 1.06354 -1.27952 +368 2 16.9014 5.84978 0.373955 -3.48337 6.90323 -1.87832 +369 2 16.58 7.23266 18.3971 4.62858 -6.17573 2.16922 +370 1 8.83009 6.92284 7.82744 0.252992 -5.92817 5.57761 +371 2 9.76137 7.15634 7.81451 4.22584 7.3373 -3.58966 +372 2 8.73794 6.33872 8.59756 -2.97854 -0.622916 -4.66555 +373 1 12.3396 0.625886 1.18148 -8.16379 -0.652746 9.01197 +374 2 13.1345 0.755236 1.71568 4.24005 -1.61972 -8.33969 +375 2 12.5055 18.5332 0.58867 3.80642 2.13695 -0.293066 +376 1 5.66619 15.1148 14.5143 -6.5884 11.0519 3.391 +377 2 4.74474 15.2404 14.7783 -0.0534379 -6.99417 -3.01637 +378 2 5.9729 15.9975 14.2655 4.1321 -4.56061 -2.72375 +379 1 3.84883 6.51764 1.70764 -0.24517 -12.2729 -5.84301 +380 2 3.34882 7.24325 1.31145 3.38543 6.95106 5.25371 +381 2 3.97654 6.73657 2.63696 -3.88246 4.168 -0.0932901 +382 1 3.88114 11.6142 12.2659 5.57001 4.81087 6.19714 +383 2 4.75444 11.9544 12.4977 1.45427 -2.38077 -3.49117 +384 2 3.27884 12.2304 12.6965 -5.21243 -4.02352 0.863052 +385 1 5.43603 3.86764 15.8623 7.54926 19.6814 5.52869 +386 2 6.13377 3.21124 15.7334 -3.30504 1.34649 -4.68995 +387 2 5.89589 4.73554 15.9355 -10.2176 -19.0214 -2.32011 +388 1 14.4546 10.3201 4.4055 -4.6195 -17.8145 -6.66778 +389 2 14.5894 9.8066 5.2203 1.29615 2.58376 -6.73886 +390 2 14.6351 9.71867 3.64602 0.226975 12.0799 18.4878 +391 1 7.91148 17.3357 9.20787 -1.7112 -7.64626 2.59046 +392 2 7.14677 17.4921 9.78359 1.89149 7.49144 -9.53339 +393 2 7.98506 17.9868 8.49476 -7.16328 0.988414 5.46347 +394 1 4.5072 14.4394 3.95775 1.71054 11.4257 7.67338 +395 2 4.60793 15.3916 4.19235 0.708777 -20.878 -0.615863 +396 2 4.75094 13.8726 4.71695 -2.09911 13.0171 -9.33913 +397 1 14.3103 7.38832 15.7657 0.217846 1.64546 9.18842 +398 2 15.2433 7.23588 15.5844 -0.0812074 1.42566 -0.574095 +399 2 14.3036 7.75428 16.6621 0.0607731 -0.988243 -5.21848 +400 1 2.8988 18.2304 1.89629 8.58281 11.0644 9.98123 +401 2 2.46496 17.5082 1.44481 -2.59003 -3.64619 -8.76243 +402 2 2.19471 18.7603 2.28641 0.940953 -0.0494932 1.95923 +403 1 7.97286 1.6093 4.54004 -3.7555 -8.8471 12.6183 +404 2 7.33734 2.04506 3.96057 8.79876 5.02214 -6.32296 +405 2 8.86006 1.965 4.43164 -2.78989 3.02833 -7.03085 +406 1 2.61876 14.1356 17.7492 -10.3822 -13.3904 -3.64852 +407 2 1.93119 13.4601 17.9363 9.46205 16.209 2.13837 +408 2 3.45643 13.7285 18.0162 -4.37303 1.24885 0.341178 +409 1 0.743255 1.70456 13.8731 3.59522 3.89384 -8.23695 +410 2 0.90651 1.38191 14.7629 -6.62821 1.47751 3.8543 +411 2 18.4338 1.82907 13.7582 5.96409 -0.15878 4.57237 +412 1 4.54424 18.6047 13.95 -3.57477 5.05027 -2.13798 +413 2 5.48468 18.3837 13.9843 -5.3566 -3.00882 -0.547935 +414 2 4.15141 18.3634 14.8001 4.77528 1.99072 0.545271 +415 1 7.0969 0.526127 18.3635 1.96349 3.45814 -4.17057 +416 2 7.27221 0.201121 17.4702 1.10961 -1.44826 4.33327 +417 2 6.13787 0.588122 18.4485 3.2238 7.1666 2.24 +418 1 16.0917 18.4266 14.1084 2.59329 0.57669 -10.3481 +419 2 15.3502 17.9157 13.7545 1.31994 6.64432 9.22997 +420 2 15.9271 18.7357 15.0116 -3.89333 -11.6647 -1.43214 +421 1 10.0733 4.52495 16.275 12.9842 -2.30982 2.85456 +422 2 11.0043 4.70153 16.4703 -2.64404 5.32532 -3.085 +423 2 10.0864 3.57376 16.1251 -6.72333 -0.470122 -1.54666 +424 1 15.8636 17.8904 4.42819 -6.03116 8.53171 5.31621 +425 2 16.3871 18.7073 4.48664 -0.23776 -8.88425 -2.03055 +426 2 14.9745 18.1441 4.72479 9.46919 -4.85854 1.60726 +427 1 6.9475 17.372 13.7315 15.8768 1.84738 17.2901 +428 2 7.36738 17.5483 14.6019 -4.78498 1.02898 -17.1267 +429 2 7.68915 17.2477 13.1142 -8.54431 1.43966 5.77183 +430 1 13.2923 6.53747 6.71701 -11.5961 -7.93952 14.6915 +431 2 14.1983 6.84596 6.64723 3.17712 4.25021 -11.0614 +432 2 12.8934 6.43009 5.84838 7.58936 1.28323 -8.80485 +433 1 7.69653 2.37351 9.2065 12.517 1.33593 -3.6252 +434 2 7.21057 2.29 10.0355 -5.39375 -0.506169 -1.44147 +435 2 7.12159 2.1318 8.46594 -3.32624 -2.43573 8.05936 +436 1 15.157 14.8759 13.6545 4.5209 -3.06988 2.24561 +437 2 15.0369 15.0852 14.5928 -3.37623 1.75424 -5.30162 +438 2 14.3708 15.1144 13.1546 1.18854 2.2818 3.55032 +439 1 9.31032 8.32311 3.71462 16.317 -0.492826 6.27183 +440 2 10.1522 8.77498 3.89843 -7.06732 -0.949504 -0.86517 +441 2 9.4815 7.39306 3.91425 -6.58464 2.05554 -3.01208 +442 1 17.7054 13.4931 16.4528 -2.79698 17.5255 -9.98682 +443 2 16.7518 13.3863 16.3682 2.15912 -8.30505 3.41837 +444 2 17.8443 14.3312 15.9805 5.97419 -5.13367 5.17943 +445 1 5.02162 10.6562 2.64136 -2.02283 -9.27068 2.47877 +446 2 5.69056 10.1772 3.15718 -2.95942 7.94984 0.663407 +447 2 4.59516 11.2797 3.2389 2.78246 -2.35968 2.10645 +448 1 3.7261 8.35111 10.2906 -2.0647 -5.12326 -12.4171 +449 2 3.87558 9.26669 10.0174 -1.23075 2.88832 6.28188 +450 2 3.61938 8.33938 11.2471 1.47542 3.72119 -0.959794 +451 1 16.077 7.09208 6.26442 0.512876 -15.8531 0.565556 +452 2 16.8498 7.55114 6.61759 -4.58181 2.74438 -1.19615 +453 2 16.2841 6.14901 6.36212 0.103861 8.35624 -6.71996 +454 1 15.1586 7.03156 9.12145 1.35056 8.00181 -20.3615 +455 2 15.9739 7.38238 9.50783 -5.19642 1.69713 -0.962803 +456 2 15.0724 7.48187 8.24992 4.14438 -5.93719 19.2407 +457 1 6.4279 13.1173 12.8809 -5.50985 -11.8139 -9.3985 +458 2 7.12916 12.5687 13.2568 1.68182 7.24531 -2.67671 +459 2 6.29661 13.8986 13.4214 -0.338885 -0.946459 7.65298 +460 1 12.1214 4.48617 13.0834 13.9874 7.50725 -12.3985 +461 2 12.203 4.65044 14.031 -7.85782 -1.77094 2.73271 +462 2 11.2673 4.11709 12.8488 -4.68474 -5.36964 10.3853 +463 1 11.3361 8.19542 7.84742 15.1179 -11.1226 16.1752 +464 2 12.0446 7.62229 7.53485 -1.89389 0.170875 -13.8157 +465 2 11.6069 8.28902 8.77112 -9.48953 8.11742 -0.143346 +466 1 17.184 10.7876 7.43369 13.5323 -0.921102 -17.174 +467 2 17.9233 10.1981 7.20811 -10.1233 -1.22821 11.3165 +468 2 17.1161 11.3267 6.63249 -5.49276 7.55364 9.36769 +469 1 5.23991 18.1348 11.0582 -10.3762 -3.21686 -5.77572 +470 2 4.63631 17.985 11.8048 7.12888 1.45886 -5.61107 +471 2 4.69408 18.0516 10.2533 5.93648 2.65605 9.16476 +472 1 7.56507 17.5919 1.8299 2.38736 9.59194 1.23507 +473 2 7.95273 16.7967 1.45285 -6.05148 -1.8022 -9.76241 +474 2 7.59068 18.2848 1.14776 -2.89899 -11.2976 1.8216 +475 1 1.88529 12.921 13.6059 -1.54804 -3.98178 5.6231 +476 2 1.43748 12.3178 14.2147 5.26513 0.934067 -3.79148 +477 2 2.14524 13.6768 14.146 -0.717118 1.88599 -5.70238 +478 1 9.71545 6.78651 14.8047 -15.2171 15.1422 7.50698 +479 2 9.90531 5.90708 15.1331 4.86835 -12.5985 -3.10865 +480 2 10.0627 6.91606 13.92 3.16992 -4.80507 -4.41639 +481 1 15.2317 4.3547 10.7806 -19.2619 -13.8042 -17.3299 +482 2 16.1692 4.17769 10.7161 9.63774 3.67614 12.8518 +483 2 15.0389 5.06132 11.3962 11.3469 5.0749 6.12787 +484 1 11.2086 6.13697 0.180528 -13.4008 -14.4307 -10.9666 +485 2 11.2654 5.18187 0.0337896 12.1183 5.06406 4.26486 +486 2 10.2799 6.29806 18.6081 2.85376 11.1709 5.84358 +487 1 0.155975 11.3317 15.1259 -12.2739 12.4049 -22.3111 +488 2 18.2869 11.6878 14.3448 9.29886 -6.35489 23.8975 +489 2 18.7388 12.0248 15.8046 -8.78344 -4.02614 -5.34871 +490 1 7.07225 9.17108 7.27057 -4.95781 3.28344 -6.42365 +491 2 6.44778 8.45946 7.46529 5.34767 -0.253084 5.87629 +492 2 7.94637 8.76128 7.25029 -3.14507 0.531691 2.27088 +493 1 18.4147 15.4309 12.3592 -5.86353 -0.606553 -5.09086 +494 2 0.72281 15.5186 12.2612 4.29187 -2.85716 2.67478 +495 2 18.0791 15.7216 11.5043 -3.32345 0.421348 1.66841 +496 1 16.5543 4.36503 5.23509 20.0373 -2.39618 26.5758 +497 2 16.7455 4.21973 6.1845 -16.121 -2.23612 -11.2684 +498 2 17.4558 4.42117 4.89188 -6.1573 5.26009 -14.9538 +499 1 17.766 3.07261 10.7271 -5.62269 10.8805 -1.85707 +500 2 0.0408353 3.2985 10.945 -3.12308 -7.03453 -2.35326 +501 2 17.719 2.23067 10.252 6.41295 1.44898 4.1666 +502 1 12.3026 0.0397215 10.1517 -5.9029 17.7484 6.25384 +503 2 11.458 0.404705 10.4688 2.82225 -9.87605 -6.68676 +504 2 12.8944 0.808865 10.1781 1.22751 -9.09827 -0.112681 +505 1 10.357 9.81077 12.3435 10.1956 0.0137966 -0.104503 +506 2 11.132 9.85287 12.9219 -4.83247 1.57396 1.64677 +507 2 10.2731 8.87192 12.148 -4.78867 -1.2901 1.32484 +508 1 0.505846 2.83821 7.01562 3.91094 -2.13436 13.3247 +509 2 0.681162 3.5182 7.67504 1.89272 4.99945 -7.1411 +510 2 0.694039 2.0503 7.53478 0.801338 -5.04329 -7.26695 +511 1 0.437103 15.2686 6.90942 10.3075 -26.8847 6.28938 +512 2 0.575652 15.2733 7.87231 -4.50905 3.86257 -7.07916 +513 2 0.764375 14.3681 6.66626 -11.1886 22.2654 -1.84191 +514 1 16.9895 7.01682 15.3107 -21.8777 2.45652 -5.46979 +515 2 17.7216 7.6089 15.1142 9.4824 -7.00642 -0.959024 +516 2 17.2645 6.09907 15.4073 14.9833 2.67634 2.96399 +517 1 9.01274 12.4171 8.12853 10.6441 15.1284 15.6095 +518 2 9.41612 11.8292 7.47716 -12.8498 -4.61215 -9.56742 +519 2 8.05003 12.5053 8.0704 6.97129 -9.84551 -10.1137 +520 1 1.26391 1.92336 3.04659 2.32337 -11.3487 -0.982019 +521 2 0.972058 2.42084 2.27545 2.43588 3.35199 3.68236 +522 2 1.90572 2.43981 3.5544 -5.46738 3.49891 -6.33947 +523 1 4.13143 15.1122 9.67174 -10.3949 2.47722 13.8895 +524 2 4.06276 15.2642 8.72313 5.39511 -1.60046 -0.0768584 +525 2 4.99495 14.7433 9.87874 3.88633 -1.07729 -6.21534 +526 1 7.19145 2.18155 14.5787 4.86443 0.520714 0.489557 +527 2 6.89453 1.81445 13.7426 1.87671 -5.23084 1.53267 +528 2 7.73681 2.92919 14.317 0.289792 2.5421 2.67041 +529 1 18.6 14.6947 2.16091 -2.26171 3.41683 0.482467 +530 2 0.820032 15.117 2.19003 5.03273 -5.31768 -1.38278 +531 2 17.9827 15.4314 2.17519 -7.65677 -2.44766 2.74205 +532 1 9.95161 2.77613 12.9401 9.45852 -1.28953 0.462065 +533 2 9.84872 2.18467 12.1812 -5.82301 1.90383 1.05008 +534 2 9.27924 3.46642 12.8986 -6.28602 -3.28272 -2.83121 +535 1 2.83159 8.92314 13.0298 -5.32883 -6.03653 -2.71455 +536 2 3.23927 9.77312 12.842 3.02047 6.8466 -0.359778 +537 2 3.51958 8.34046 13.3637 5.40811 -1.61307 4.23789 +538 1 3.22435 8.37789 3.65229 -1.03338 2.31116 19.4552 +539 2 3.68753 9.01983 3.09696 -0.346577 4.63804 7.35474 +540 2 3.38788 8.57936 4.60408 0.951973 1.27409 -22.7571 +541 1 5.6137 7.19416 8.52025 7.21613 5.80474 -6.44533 +542 2 5.78863 6.24316 8.52523 -9.99458 0.454093 3.85202 +543 2 5.0179 7.43184 9.24037 0.527922 -7.72891 3.36669 +544 1 14.8805 1.29251 2.00129 6.0675 21.6566 -5.88084 +545 2 14.8065 2.10545 2.50153 -6.7285 -1.94379 16.9269 +546 2 15.1655 1.66296 1.16284 -0.437229 -14.9075 -12.229 +547 1 8.26451 15.1933 0.836486 3.22704 -2.0235 12.9462 +548 2 8.92324 15.2163 1.54184 12.9519 -3.35665 -8.03315 +549 2 7.55879 14.6837 1.25205 -6.95241 0.364363 -7.46808 +550 1 15.625 1.34415 7.23495 -17.3283 -0.11068 -5.87671 +551 2 14.9596 0.769214 6.81661 10.6011 2.38946 3.65492 +552 2 15.1493 2.17629 7.38417 4.13791 -2.68619 2.35471 +553 1 4.93041 13.0764 18.5264 9.84655 1.48115 -2.02825 +554 2 5.35318 13.1968 0.744685 -3.49153 -1.64799 -2.34468 +555 2 5.56664 13.4414 17.8965 -2.33559 -1.35641 1.38511 +556 1 15.3557 8.48379 18.1448 0.204246 14.4785 -5.82183 +557 2 15.7265 9.09289 17.4831 -0.830936 -8.68367 1.885 +558 2 15.168 9.07051 0.245745 1.7123 -4.50429 2.39894 +559 1 12.0892 3.02993 18.3645 -15.9576 34.4498 -4.49703 +560 2 11.9769 2.60431 0.571005 13.6468 -16.1673 -1.05926 +561 2 12.5269 2.48004 17.7153 4.47893 -15.6345 5.41851 +562 1 13.2117 12.674 5.1931 -10.339 11.1011 -13.5125 +563 2 13.668 11.9204 4.80624 6.1285 -2.92776 7.79567 +564 2 13.4681 12.7869 6.11335 2.67539 -7.97004 0.458585 +565 1 6.0506 7.06933 0.0406962 1.31452 -3.72946 4.6718 +566 2 6.04306 7.98784 18.9476 0.374235 14.6189 -4.65006 +567 2 5.24553 6.71887 0.435288 -0.866845 -3.58603 0.782556 +568 1 17.739 15.9899 15.0125 -12.5206 6.16285 -12.4036 +569 2 16.945 16.5161 15.03 -7.46495 5.1976 21.0221 +570 2 17.8264 15.955 14.0627 17.7161 -15.0875 -11.5838 +571 1 13.1794 1.00208 16.5735 3.37979 -5.34722 -6.70143 +572 2 14.139 0.860857 16.6169 -5.21536 -1.33728 6.50102 +573 2 12.8035 0.137283 16.3512 2.48828 2.22182 6.02943 +574 1 11.096 14.5828 7.22348 0.0189977 4.74793 7.83345 +575 2 10.4045 14.1614 7.73717 -8.54387 -1.14011 0.371667 +576 2 11.8979 14.1335 7.50232 3.58446 -6.30574 -4.63725 +577 1 17.5104 8.62105 2.08846 14.2737 4.97696 2.51664 +578 2 16.6904 8.42754 2.54903 -5.27316 -4.4343 -3.04137 +579 2 17.6167 7.98338 1.37729 -7.36397 -7.55614 -1.26172 +580 1 12.3515 7.96855 1.99107 6.37927 0.258975 7.77687 +581 2 12.1159 8.90068 1.90258 -3.43959 -5.51169 -5.98444 +582 2 11.9581 7.4701 1.26507 -2.67829 1.90847 0.988543 +583 1 11.8954 14.6159 10.3514 1.85125 4.19108 3.73581 +584 2 12.1615 13.856 9.81631 -7.50724 5.70574 2.33101 +585 2 10.9524 14.815 10.2079 9.27078 -9.38408 -0.682121 +586 1 6.88225 7.03081 15.6002 -4.063 -7.66118 -6.77733 +587 2 7.75096 7.17076 15.1857 -5.63662 2.89282 10.0227 +588 2 6.77779 7.6167 16.36 6.70206 0.515961 -5.66863 +589 1 8.00078 4.70171 13.472 -1.59283 -4.83357 -4.64481 +590 2 7.27623 4.81783 12.8396 5.32657 -1.99722 0.885811 +591 2 8.48998 5.527 13.4768 -0.383179 2.4117 0.469228 +592 1 13.3975 12.1709 14.2706 1.21587 3.44049 5.53322 +593 2 13.2724 11.2098 14.2197 -1.68144 4.93388 -3.39254 +594 2 13.8611 12.4606 13.4725 -0.646036 -5.76058 -0.123004 +595 1 14.8166 9.4384 7.29692 -7.31149 -4.84482 -6.71483 +596 2 15.6063 9.98387 7.39943 -3.2576 1.32409 4.65546 +597 2 14.0612 9.86586 7.70853 4.31514 4.68737 1.52589 +598 1 12.6657 17.0265 3.08863 -0.499632 18.4226 10.5493 +599 2 13.0409 17.4141 3.89779 -4.03665 -9.69042 -5.1428 +600 2 12.0457 17.7132 2.78031 5.51866 -13.6109 -0.0343421 +601 1 1.16791 7.14337 17.4519 -17.3777 -0.471365 -9.17207 +602 2 0.285968 6.88879 17.7816 4.71885 8.57951 0.206219 +603 2 0.996987 7.64547 16.6337 5.09703 -7.79381 5.85561 +604 1 12.7928 5.13809 15.6672 21.9233 -6.79759 1.12632 +605 2 13.5314 4.49934 15.6812 -12.3388 3.06691 0.377185 +606 2 13.2535 5.99313 15.6546 -7.1176 -2.71451 -0.771614 +607 1 2.50804 3.40102 5.01245 -9.19737 1.42964 37.6951 +608 2 1.85734 3.08405 5.69632 14.2768 7.06331 -19.9109 +609 2 3.04485 4.07021 5.49582 -10.9118 -9.07044 -17.2872 +610 1 8.33238 11.2579 13.4651 -31.1482 13.4197 6.60268 +611 2 8.24927 11.0816 14.4232 19.8118 -8.42601 -14.5581 +612 2 9.11403 10.9307 13.0113 5.91799 -11.9552 15.0186 +613 1 12.8978 1.37199 13.3367 -3.68795 11.8567 -21.2004 +614 2 13.3586 1.33808 12.4821 5.12584 -5.42725 10.3839 +615 2 12.3812 2.18266 13.2296 0.582289 -3.8456 10.447 +616 1 6.35916 13.6786 2.13932 11.022 -2.36774 12.7417 +617 2 5.81416 14.065 2.83164 -5.92624 2.48265 -4.44044 +618 2 6.97105 13.1303 2.64934 1.90703 -2.61302 -7.4669 +619 1 15.9256 6.59608 12.7788 -4.50753 -7.00075 -5.11208 +620 2 16.441 7.14613 12.1828 -0.0403293 3.27533 -1.15613 +621 2 16.337 6.66123 13.6439 3.64448 2.92523 3.21919 +622 1 16.8436 0.710185 9.59384 -10.8386 -3.59173 0.641976 +623 2 16.678 18.424 9.8391 7.1202 6.86076 -6.23598 +624 2 16.34 0.863872 8.77611 6.63769 -2.37412 0.960785 +625 1 6.14874 11.7365 8.37914 -9.33508 -33.9533 -7.34454 +626 2 5.23473 11.5355 8.67103 13.3879 7.28881 -1.35634 +627 2 6.50048 10.8558 8.08418 -3.72877 24.3898 8.07481 +628 1 2.86629 8.64627 0.414665 29.1459 -9.93647 1.24251 +629 2 2.37091 8.1673 18.3782 -14.09 11.8062 8.4924 +630 2 2.39345 9.32329 0.907466 -18.2396 -1.77699 -9.50941 +631 1 10.1496 10.4602 6.51654 2.68196 -4.3054 1.18084 +632 2 10.6351 9.79475 7.02051 -3.21697 0.687034 0.899044 +633 2 10.5797 10.4719 5.65285 -1.94715 4.18574 1.72512 +634 1 6.74842 15.6916 6.55665 -2.66838 16.8954 6.36263 +635 2 7.13132 16.1354 7.32023 -0.325366 -7.45035 4.57015 +636 2 6.8063 16.3799 5.88394 5.31174 -8.689 -7.83261 +637 1 6.45137 13.1469 5.60457 -4.49761 -5.86725 0.527716 +638 2 6.60666 13.9979 6.03098 2.95924 -2.27328 1.19215 +639 2 5.97977 12.5923 6.23705 2.74812 2.58161 1.74453 +640 1 16.8067 12.5538 9.81832 0.32671 -4.80998 5.18546 +641 2 16.9975 11.894 9.13199 -1.38663 9.72579 -2.40586 +642 2 16.8023 13.4365 9.43343 1.83869 -5.34542 -5.01893 +643 1 6.05747 2.94525 2.83457 1.69886 0.640591 -2.15275 +644 2 6.28227 3.83854 2.57267 5.15417 9.09864 3.82618 +645 2 5.67557 2.57416 2.03485 -2.61266 -9.3622 -0.552159 +646 1 10.8942 3.30264 3.28891 6.21412 -5.01644 3.41466 +647 2 10.2824 3.98758 3.58006 -2.01501 -0.119341 -5.67488 +648 2 10.543 2.90591 2.48434 -5.60317 1.35459 0.297545 +ITEM: TIMESTEP +30 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.7097 7.05343 17.9609 20.7509 -2.32452 -4.15205 +2 2 7.78893 6.94819 18.1674 -15.0431 -3.26874 3.90688 +3 2 8.91258 6.41114 17.2706 -4.14568 0.140094 0.745653 +4 1 18.6207 8.28878 6.84456 -10.9758 14.7568 -16.4597 +5 2 0.033254 8.12327 5.87995 7.78297 -6.3031 11.7942 +6 2 0.390602 7.58629 7.343 9.14113 -10.4614 1.3502 +7 1 8.4202 18.5906 6.81681 -12.3331 6.77681 2.70587 +8 2 9.32414 0.194792 6.65918 12.4366 2.53215 -2.1327 +9 2 7.89923 0.683074 6.46691 2.1768 -2.64942 -1.08929 +10 1 6.58134 1.82408 11.6823 -18.6778 6.99539 14.5251 +11 2 5.88329 2.28495 12.2086 12.5233 -11.9933 -14.8966 +12 2 6.20729 0.949756 11.4934 -0.484037 1.974 1.03676 +13 1 7.10261 5.71907 2.36398 18.2567 -30.46 4.77574 +14 2 6.748 6.26194 3.05915 -16.1408 13.0855 0.817955 +15 2 6.89353 6.07497 1.50557 -7.56713 14.4666 -6.71064 +16 1 16.2146 10.1912 16.1045 25.8326 -16.9059 -6.28167 +17 2 17.1924 10.2614 15.9892 -26.0275 4.96146 3.01812 +18 2 15.8649 11.0425 16.3511 -1.01593 12.6392 3.03555 +19 1 10.6309 14.9782 2.32852 5.54907 12.6484 -4.66534 +20 2 10.5683 14.607 3.21596 0.623447 -1.40903 0.430751 +21 2 11.0949 15.8303 2.43151 -6.58286 -12.6372 2.6945 +22 1 17.1592 8.25618 10.4876 -10.0218 -2.97818 8.46282 +23 2 16.7485 8.99843 10.9576 2.65758 -6.15573 0.24812 +24 2 17.9939 8.575 10.1448 6.84049 6.50961 -0.847785 +25 1 14.8275 15.8902 16.3678 -10.7483 8.55828 -7.5541 +26 2 13.911 16.2262 16.382 8.40977 -5.5752 2.0788 +27 2 14.9328 15.3229 17.136 -2.68587 0.983086 7.72287 +28 1 12.1445 13.398 0.450021 7.16446 -9.51802 2.88894 +29 2 12.0254 13.4023 18.1304 -4.57533 9.09159 6.34311 +30 2 11.5749 14.0284 0.911779 -3.72154 -0.858053 -5.79964 +31 1 9.27791 5.43254 4.03115 12.5872 2.27984 -15.9713 +32 2 8.88042 5.04351 4.80522 -11.7175 -1.93285 8.71688 +33 2 8.63164 5.36398 3.31053 -0.238489 1.95718 4.1093 +34 1 1.81582 4.23406 11.6392 3.52665 -33.0533 9.77708 +35 2 1.78778 5.15359 11.8657 -3.54286 18.5189 3.84305 +36 2 2.12638 3.75505 12.4373 -4.00166 7.6753 -17.1576 +37 1 1.99877 6.82017 8.35649 4.97761 -1.46296 10.7796 +38 2 2.31944 7.23424 9.17304 -0.0326511 4.09138 -10.3959 +39 2 2.07937 5.88268 8.56766 -7.36821 -1.33929 -3.79841 +40 1 5.395 4.41162 7.94446 4.05063 -3.43427 6.53634 +41 2 5.41133 3.44966 7.94196 6.73946 -4.4132 0.768998 +42 2 4.74595 4.62804 7.28165 -7.35272 12.6119 -8.90882 +43 1 3.28409 2.93052 17.527 4.91883 3.31559 -8.51102 +44 2 3.97895 3.44036 17.0791 -2.08356 -9.03714 -1.68785 +45 2 2.70652 3.59221 17.9099 -2.28402 5.9437 7.00724 +46 1 7.47067 5.28165 6.09824 -7.47353 5.76211 -2.63966 +47 2 7.88561 6.05707 6.46631 15.843 7.70036 2.30241 +48 2 6.86027 5.05727 6.79609 -9.98425 -16.5426 3.24835 +49 1 9.77462 7.02047 11.9927 -3.16333 0.34511 -3.92757 +50 2 10.3836 6.39122 11.588 -5.90607 3.51948 -2.51732 +51 2 9.0529 7.19715 11.3548 12.4276 -3.26368 6.69514 +52 1 14.0466 3.57679 8.07144 18.6703 -0.348541 19.5758 +53 2 13.8937 4.22019 7.39343 -5.64007 13.0869 -9.16622 +54 2 14.611 4.0279 8.7381 -15.3074 -10.3909 -10.441 +55 1 4.67183 17.2138 3.98342 -17.1629 -17.7927 10.2823 +56 2 5.57476 17.4036 4.21567 13.953 12.775 -5.74716 +57 2 4.34342 17.7474 3.25626 2.59666 4.69733 -2.98879 +58 1 16.5112 16.6016 10.1232 -22.4077 14.5184 19.5552 +59 2 15.797 16.9077 10.7255 16.9762 -11.2391 -6.18282 +60 2 16.019 16.127 9.45142 2.29692 -6.2585 -6.10264 +61 1 1.96965 4.87893 0.40906 -10.7697 -8.55226 -4.93465 +62 2 2.66061 5.27529 0.941341 5.5274 3.49831 6.88318 +63 2 1.47511 5.62215 18.6951 6.32177 2.44726 -2.78863 +64 1 11.7331 13.3335 16.3023 -6.06186 -8.167 -3.78825 +65 2 11.2597 12.4992 16.3612 -10.498 -1.32756 10.0093 +66 2 12.2577 13.1697 15.5177 8.21427 7.2284 -4.69488 +67 1 10.121 11.0486 16.9167 -7.88764 10.2638 -1.90592 +68 2 10.5124 10.1783 16.9786 2.49636 -9.86729 -0.127492 +69 2 9.16626 10.9164 16.816 6.71354 -1.99355 -1.80005 +70 1 11.7161 17.4964 13.4564 0.653858 7.10726 11.4031 +71 2 12.4343 17.1488 12.9211 3.60089 1.57548 -4.57497 +72 2 11.8646 18.4589 13.5472 2.97554 -11.89 -7.13537 +73 1 6.3779 9.31416 12.2259 -8.95234 15.1635 22.3379 +74 2 6.77463 8.98312 11.4273 14.2971 -1.19702 -8.86117 +75 2 6.96666 9.97806 12.6372 -2.9053 -11.0825 -10.5803 +76 1 16.2282 12.7644 2.6938 13.255 22.6007 -2.42149 +77 2 17.0484 13.1981 2.39924 -4.54016 -10.6437 3.48813 +78 2 15.6471 13.522 2.85837 -6.5992 -7.46489 -1.32569 +79 1 0.640508 12.5852 5.88727 21.753 -1.83143 4.54161 +80 2 0.997304 12.3975 5.01963 2.04371 1.22983 -7.11515 +81 2 18.3646 12.7399 5.72186 -19.0302 3.73655 0.683884 +82 1 5.21387 16.4194 18.454 4.66732 -1.11443 8.72996 +83 2 5.89359 15.806 18.1817 0.824082 -8.56943 -13.0935 +84 2 5.59435 16.7978 0.603858 -5.48698 7.00748 3.62952 +85 1 0.548987 7.64401 4.10842 0.670348 4.32997 2.73018 +86 2 18.6015 7.92625 3.40384 -3.24873 3.72744 -1.92559 +87 2 1.36738 8.12724 3.94642 3.53853 -5.18785 -2.83474 +88 1 3.12734 8.93117 6.50347 30.4123 1.43415 3.20415 +89 2 3.68489 8.55498 7.21169 -11.4249 4.27745 -10.9708 +90 2 2.23185 8.74841 6.74202 -19.2185 -4.73256 7.28786 +91 1 7.31515 10.3274 16.2171 -7.5998 2.86538 3.08356 +92 2 6.58991 10.5191 15.6248 2.07633 0.375924 -7.53004 +93 2 6.86928 10.3012 17.0718 3.58834 -2.41696 5.50844 +94 1 11.1056 1.03439 5.00906 5.66297 2.87297 -9.25474 +95 2 11.3082 1.81468 4.47889 -2.42802 6.95123 8.17266 +96 2 10.7866 0.43271 4.33294 -5.36858 -10.0003 1.63315 +97 1 4.38851 2.75082 13.2055 -1.16421 16.6802 -23.4007 +98 2 4.78143 3.22961 13.9394 0.315345 -9.27332 13.6616 +99 2 4.20912 1.83275 13.4212 4.21877 -6.70893 11.8835 +100 1 8.39225 10.0828 1.81263 -0.204034 19.0364 -5.60934 +101 2 8.35289 10.7959 2.47026 -1.38438 -3.08289 -2.87504 +102 2 8.81547 9.35618 2.25702 3.41266 -13.1645 6.66357 +103 1 10.4926 1.73671 15.571 11.1439 -7.64614 -12.2914 +104 2 11.3949 1.40928 15.4244 -6.59208 6.73213 11.009 +105 2 10.2461 2.06593 14.699 -6.9068 1.71228 -0.826453 +106 1 2.72763 12.9186 7.78215 1.53907 -1.41162 9.17357 +107 2 3.36352 13.5565 7.43734 -3.21302 -0.65885 -4.12251 +108 2 2.22004 12.5809 7.03913 -2.76352 5.50699 -3.09439 +109 1 3.68558 11.672 5.21041 4.08504 4.36046 -3.38247 +110 2 3.45481 10.9554 5.79468 0.598863 -9.40064 6.30918 +111 2 2.92113 11.7973 4.6466 -2.33635 3.52119 -7.07475 +112 1 6.80415 14.4796 16.8864 5.34146 -11.2852 2.95693 +113 2 7.68462 14.091 16.8709 -3.70601 4.15103 0.993665 +114 2 6.49099 14.4407 15.9783 -2.62919 9.78665 -2.68056 +115 1 14.176 14.5561 3.39307 -12.5209 -3.15767 3.59597 +116 2 13.6245 15.3467 3.3085 5.15733 -4.43597 -5.06132 +117 2 13.635 13.92 3.89178 10.6994 6.10439 -0.0738324 +118 1 8.31018 18.1523 16.0453 25.0942 2.73084 1.98444 +119 2 8.89462 17.4796 16.3723 -6.95894 -25.3404 9.38217 +120 2 8.98968 0.119946 15.7574 -11.3153 21.4924 -7.69748 +121 1 4.73581 1.63729 4.92804 -12.581 -10.4736 11.5054 +122 2 3.83953 1.97889 4.8343 1.42607 1.89675 3.67103 +123 2 5.27039 2.18299 4.37483 11.2234 12.2757 -18.577 +124 1 15.0504 12.7475 16.4383 22.4341 -19.9388 -26.396 +125 2 14.708 13.1949 17.1966 -19.6268 9.49299 12.0559 +126 2 14.4413 12.6723 15.6738 0.429593 5.89098 19.3668 +127 1 15.7794 18.4162 16.8297 -23.8108 0.224717 -24.365 +128 2 16.2557 18.6157 17.6209 13.9809 -1.68 17.1984 +129 2 15.4229 17.5182 16.8969 9.44127 2.10519 2.83182 +130 1 1.1656 1.1613 16.5455 9.88565 -3.33075 -8.05438 +131 2 1.89055 1.78579 16.6066 9.02992 -0.102422 -1.61706 +132 2 0.673214 1.35844 17.3295 -13.4515 3.62078 11.8035 +133 1 18.1028 4.54571 15.8941 -4.73113 6.48399 7.96005 +134 2 18.5013 4.04336 15.196 5.27298 -10.1152 -10.2677 +135 2 18.7433 4.58481 16.606 1.22293 0.259147 -1.01212 +136 1 12.236 16.9836 16.146 14.9412 3.5391 -27.9779 +137 2 11.6416 16.3841 16.5672 -17.548 -8.54782 13.2608 +138 2 12.0887 16.8479 15.1863 -0.907912 9.23395 13.7712 +139 1 15.9498 2.53257 18.0253 10.6473 -13.6828 8.83411 +140 2 15.5627 3.24781 18.526 -5.22656 12.7326 -1.10284 +141 2 15.751 2.68965 17.0989 -3.04742 3.76351 -4.61681 +142 1 6.7038 13.8197 10.2271 2.9338 -17.2727 -3.34939 +143 2 6.61667 13.5512 11.144 -2.24755 5.72821 7.93099 +144 2 6.68776 12.9653 9.76874 -1.43812 10.35 -6.56898 +145 1 10.1318 18.2649 2.7724 -13.411 -9.16786 2.85058 +146 2 10.3828 0.244178 2.09267 2.54842 10.4954 -6.81354 +147 2 9.19143 18.056 2.59362 16.7762 1.59207 3.74676 +148 1 2.99108 17.7409 6.10283 23.0954 -1.76337 16.2177 +149 2 2.19234 17.7622 5.58671 -8.31269 -3.84851 -15.8536 +150 2 3.76803 17.7869 5.51609 -16.1123 2.00349 -4.76697 +151 1 12.5756 16.9274 7.99763 -5.18448 9.92793 0.0594024 +152 2 11.7822 16.4009 7.94219 -1.30832 -15.7704 -9.09049 +153 2 12.3073 17.5896 8.63909 10.7698 6.45321 6.22995 +154 1 14.8838 15.2691 8.24901 11.9288 7.15592 -19.4456 +155 2 14.3219 16.0313 8.11935 -17.9047 1.82161 10.6012 +156 2 15.419 15.3185 7.43747 0.964457 -9.38205 7.76842 +157 1 17.6242 18.2515 0.369787 17.475 26.3316 2.73311 +158 2 18.5101 17.9713 0.0958777 -8.0951 -12.2782 0.813683 +159 2 17.7821 0.518901 0.686034 -9.22006 -13.9572 -3.22273 +160 1 0.867554 10.3913 1.38534 13.3292 31.3771 -20.1166 +161 2 0.0708789 9.90853 1.49908 -23.2341 -17.8443 11.3974 +162 2 0.609768 11.125 0.785047 6.92113 -8.95227 10.8017 +163 1 1.63658 12.2225 3.36866 -7.99561 -17.8946 -31.9552 +164 2 1.35203 11.5128 2.74742 7.334 6.03534 21.6261 +165 2 1.63695 12.9742 2.77054 4.15295 9.67724 10.1418 +166 1 0.571199 17.2371 4.87124 -14.5407 6.59112 32.0774 +167 2 -0.059088 17.9662 4.92138 6.12201 4.50556 -13.0577 +168 2 0.445901 16.8548 5.75927 11.2459 -10.7393 -14.745 +169 1 1.10756 0.954018 9.42478 -6.01064 0.927768 -12.2971 +170 2 1.20282 0.614567 10.324 -1.80966 -3.76099 -1.37067 +171 2 0.239583 0.659806 9.09473 9.24115 0.27684 10.6776 +172 1 16.7657 2.33783 13.2856 -4.77092 -12.7415 18.4331 +173 2 16.9235 2.53629 12.3736 4.43968 6.32108 -18.3535 +174 2 16.5017 1.40258 13.3145 0.84997 6.98888 1.09187 +175 1 2.55595 15.84 12.1915 -9.99296 7.89206 -20.2214 +176 2 3.13585 15.4219 12.8083 9.49953 -6.79049 14.4751 +177 2 2.92245 15.6515 11.3148 -0.922807 -1.51117 1.32599 +178 1 16.4223 15.613 5.98575 -3.71667 -18.1819 11.7841 +179 2 17.3247 15.5921 6.33835 -0.216171 6.69275 -4.6749 +180 2 16.2529 16.4332 5.52058 8.23488 6.69239 -4.77655 +181 1 5.80627 5.05529 11.7835 2.20346 1.03406 8.57972 +182 2 5.47099 5.61389 12.5063 0.21977 1.29573 -10.4635 +183 2 5.43215 4.18052 11.9366 -3.48089 3.11082 -1.53573 +184 1 15.1897 4.8564 0.727292 -5.49239 9.65996 -2.72664 +185 2 15.2051 4.71263 1.67299 -4.1535 -7.09946 8.01526 +186 2 14.3467 5.30742 19.2217 7.5675 -5.77492 -4.69919 +187 1 16.3443 16.3423 2.09898 -10.6702 -0.501744 21.7899 +188 2 16.0343 16.7391 2.94116 7.72577 -10.997 -12.8868 +189 2 16.4832 17.1019 1.54751 7.961 8.6491 -12.4493 +190 1 0.271558 4.86315 3.80356 2.16636 -31.8967 4.70784 +191 2 0.500225 5.77685 3.71679 7.2244 19.9811 4.59738 +192 2 1.02077 4.40389 4.23265 -9.838 12.5034 -4.93629 +193 1 2.94659 15.0442 15.0679 0.642608 -6.50925 -4.27186 +194 2 2.75789 14.5701 15.8868 0.637625 5.4096 6.54553 +195 2 2.48063 15.8876 15.1248 -0.665005 -3.22304 2.52721 +196 1 1.13823 14.625 9.55769 -40.6641 2.98648 23.3687 +197 2 1.89308 14.4183 9.03602 24.2615 -17.8348 -5.78778 +198 2 0.899054 13.8694 10.146 16.149 11.9497 -18.7143 +199 1 13.6328 16.6228 11.5317 -8.77554 -4.828 10.6654 +200 2 13.2136 17.4084 11.1616 -1.58446 0.630618 -8.00902 +201 2 13.0391 15.8864 11.302 7.59245 3.60181 -7.14688 +202 1 4.70114 1.47286 0.734685 -3.14847 1.30924 1.42089 +203 2 4.10181 2.05657 0.255283 4.3012 0.912352 -3.9516 +204 2 4.12143 0.893804 1.23429 -1.01367 -7.44934 0.356301 +205 1 1.44259 18.5254 11.8725 4.87725 -20.5249 2.38925 +206 2 1.2982 0.329643 12.7089 -1.92821 4.76162 2.3937 +207 2 1.66413 17.5975 12.0994 -0.659414 17.7173 -3.45023 +208 1 11.5206 10.1171 4.06393 -3.80452 1.00663 -6.51606 +209 2 11.2843 10.553 3.23019 1.0155 -1.19537 2.23558 +210 2 12.4827 10.1039 4.08159 3.36054 1.41703 2.51077 +211 1 8.33991 12.1729 3.71569 5.40649 2.32091 -9.4304 +212 2 9.08268 12.7024 4.00206 12.7546 1.78956 -5.29094 +213 2 7.80528 12.1916 4.49536 -21.4073 -3.06625 11.8611 +214 1 14.3677 4.01314 3.28101 5.46562 4.88363 2.56432 +215 2 15.0857 4.19963 3.89805 0.543674 -3.28085 4.74869 +216 2 13.622 4.5498 3.58084 0.572713 -1.66955 -3.63784 +217 1 5.59145 1.71061 7.51389 3.0333 8.44076 -17.8773 +218 2 4.93757 1.09228 7.83941 -4.88752 -5.30351 6.58254 +219 2 5.37448 1.80426 6.56172 4.34195 -4.37145 14.4788 +220 1 17.8887 1.09435 4.8754 -0.773263 0.600717 5.02725 +221 2 18.623 1.41887 4.35928 5.70444 0.114988 -11.5441 +222 2 17.8389 1.7231 5.59879 -7.43418 -0.321368 4.00301 +223 1 6.81825 9.41317 4.48156 7.11204 -1.13267 15.9283 +224 2 6.84118 9.52277 5.44603 -5.88151 0.934362 -6.29355 +225 2 7.74851 9.26985 4.27279 -2.06614 -3.64671 -7.13223 +226 1 2.66566 14.925 1.97184 3.43761 -5.8072 22.4208 +227 2 3.31024 14.6851 2.65976 -11.6222 2.95672 -3.26291 +228 2 3.19272 14.9753 1.1906 5.92571 0.162325 -19.2981 +229 1 17.2917 12.9099 13.1468 13.6904 -32.8575 1.82925 +230 2 16.4305 13.254 13.3667 -5.78742 18.0954 -2.54799 +231 2 17.8833 13.5932 12.8229 -8.84805 15.1913 2.15275 +232 1 14.9839 10.5629 1.38454 25.7264 11.2091 10.263 +233 2 15.6084 11.2587 1.71974 -19.4135 -18.6888 -7.72567 +234 2 14.1549 11.0026 1.25075 -10.8149 6.915 -1.22185 +235 1 5.70372 6.84607 4.55662 8.80438 8.80025 -0.823305 +236 2 6.10735 7.7373 4.58073 -7.50282 -10.5851 -1.04914 +237 2 6.32636 6.24858 4.99 1.7616 -0.154003 4.43374 +238 1 8.04871 8.29405 10.2754 3.94684 3.34606 -22.4081 +239 2 8.71637 8.94856 10.0317 -1.03323 4.34225 9.84614 +240 2 7.78699 7.97842 9.39774 -4.16124 -6.72066 12.7971 +241 1 13.4913 18.3469 5.77892 -1.26098 13.9384 -13.7404 +242 2 12.815 0.368504 5.57583 1.14564 -3.93427 -2.76608 +243 2 13.0908 17.8361 6.47463 -1.65231 -11.4802 12.6171 +244 1 0.227007 2.59645 0.141675 -14.0496 12.7254 8.33212 +245 2 17.9751 2.93781 18.665 -4.73692 -13.8452 -6.2234 +246 2 0.694599 3.38298 0.431909 14.3746 0.669884 0.426623 +247 1 12.7219 11.0238 9.75183 49.8657 -12.692 14.413 +248 2 11.8223 11.0616 9.49871 -31.5247 -8.5727 -6.88909 +249 2 12.9406 10.0926 10.0008 -12.7634 16.4478 -4.29644 +250 1 0.765495 12.2256 11.092 -6.27201 -3.92882 -21.6672 +251 2 18.4439 12.3344 11.0429 5.26844 -2.50397 8.5312 +252 2 1.08097 12.384 11.9788 -3.27397 5.59862 9.72518 +253 1 5.06534 7.27352 13.4491 9.82463 3.8805 6.07585 +254 2 5.60445 7.97165 13.048 -4.44492 -2.76176 -4.56894 +255 2 5.50693 7.14172 14.2991 -3.01503 -3.24863 -0.495805 +256 1 1.24722 6.90803 11.85 29.2977 26.916 27.8288 +257 2 0.522094 7.24638 11.3513 -16.2758 4.78156 -11.2742 +258 2 1.67283 7.72942 12.2344 -11.891 -29.9717 -16.3043 +259 1 15.4903 9.51892 12.3126 7.40517 -6.095 -16.4028 +260 2 15.1231 10.4002 12.2744 -2.67202 9.46709 6.64342 +261 2 15.3464 9.12903 13.1709 -3.09066 3.82816 8.99587 +262 1 16.6298 12.8631 5.48891 1.11523 -3.92575 5.75418 +263 2 16.4995 13.8048 5.46845 -2.55881 16.2829 11.3267 +264 2 16.4805 12.6501 4.57692 -1.87933 -15.1854 -15.6508 +265 1 6.21094 9.97472 0.0957231 23.6487 -5.34392 2.82943 +266 2 5.60453 10.4038 0.703481 -3.26342 3.61778 2.3496 +267 2 7.09538 10.0231 0.521798 -18.1891 -1.30215 -0.820391 +268 1 12.348 6.08762 4.05307 2.0614 24.7942 -10.4953 +269 2 12.1492 6.85087 3.46448 11.8353 -14.4305 6.54315 +270 2 11.534 5.60454 4.05688 -13.4451 -11.2489 2.03158 +271 1 0.182227 12.8112 0.197519 7.97213 -0.157956 2.72486 +272 2 0.124577 13.5143 0.856815 -1.71897 -0.134619 0.137441 +273 2 18.3975 13.1734 18.0617 -3.09196 -0.84285 -5.0356 +274 1 3.77998 18.5905 8.57799 -18.8802 5.92516 7.26956 +275 2 3.52251 17.9827 7.88131 5.13558 -0.560148 -6.56591 +276 2 2.92387 0.359522 8.79319 10.0752 -0.462424 4.43469 +277 1 7.44275 17.2901 4.46744 -21.5086 -34.4409 7.51913 +278 2 7.83961 18.0981 4.73248 10.1677 27.4444 -0.194329 +279 2 7.33826 17.2675 3.51576 6.23588 9.30645 -6.08156 +280 1 9.24103 17.0711 12.2479 -19.3743 11.7076 -0.715804 +281 2 9.17102 16.3949 11.5719 7.91635 -8.00505 -0.934966 +282 2 10.0835 16.9964 12.6894 10.2718 -1.4174 0.528472 +283 1 13.295 12.9281 7.96455 10.8524 35.2373 8.53109 +284 2 13.4175 12.2933 8.66577 -5.31299 -13.0614 2.94334 +285 2 13.7676 13.7325 8.27776 -0.249345 -13.5851 -11.5496 +286 1 14.9473 2.96516 15.3472 -8.56764 -6.90335 7.41648 +287 2 14.4704 2.13858 15.1989 -5.86972 7.46703 2.11397 +288 2 15.5773 2.99488 14.6333 9.67131 3.29159 -8.66831 +289 1 9.8733 15.5399 16.9999 -1.15808 -3.26391 2.43146 +290 2 10.4067 14.7753 16.7398 -3.17357 -1.97936 0.56939 +291 2 9.29049 15.2638 17.7267 6.50431 4.19029 -1.43758 +292 1 11.3155 8.30103 16.5489 -8.97523 -12.184 6.64215 +293 2 10.5995 7.86385 16.0596 7.08532 7.34183 -0.412451 +294 2 11.4953 7.67267 17.2664 2.19784 9.25982 -2.90547 +295 1 3.86136 18.202 16.7472 -0.00540616 -19.6914 -20.2162 +296 2 4.27115 17.4628 17.2262 -1.12743 11.6131 4.05136 +297 2 3.85436 0.333712 17.2887 2.36829 10.2975 15.3313 +298 1 2.18996 4.14488 8.93819 0.886129 3.08448 -7.12661 +299 2 3.10445 4.02058 8.72725 13.9566 -1.85365 -12.2229 +300 2 2.19804 3.9794 9.87086 -10.6985 1.40109 20.9797 +301 1 9.87077 10.3617 9.71962 10.1113 -1.13074 11.4426 +302 2 9.57245 11.1887 9.34333 -7.01747 6.00246 -6.1834 +303 2 10.1269 10.5679 10.6319 -2.96085 -6.85282 -1.29137 +304 1 9.72151 0.827202 10.8565 -16.8019 0.79505 -1.6906 +305 2 9.17924 18.7332 11.1654 13.4836 -3.87865 6.80866 +306 2 9.14124 1.21724 10.1941 6.30814 7.82285 -3.72399 +307 1 9.21217 15.15 10.2242 6.46373 1.33184 2.55262 +308 2 8.76537 15.794 9.67699 -2.80645 8.81337 -5.09524 +309 2 8.53339 14.5081 10.4276 -6.91387 -6.36492 -2.48134 +310 1 0.979873 9.39617 10.3168 -32.1534 32.2854 2.26584 +311 2 1.01417 10.3672 10.3328 -11.1793 -7.1298 6.70775 +312 2 1.8685 9.20872 10.1515 40.6499 -19.8378 -9.87175 +313 1 16.9127 4.85919 8.18774 -4.59801 12.0977 -12.3954 +314 2 16.2737 5.53573 8.4435 0.928859 1.2732 2.05393 +315 2 16.9639 4.27263 8.93179 4.52425 -11.0836 8.47724 +316 1 14.6737 14.709 0.318185 15.3338 2.15239 -13.9805 +317 2 15.2295 14.9726 1.0606 -1.701 5.56475 -1.20644 +318 2 13.8551 14.4222 0.702232 -12.5496 -7.63291 5.74768 +319 1 3.57822 11.0521 9.58832 7.05767 -0.848593 3.86503 +320 2 3.70772 11.5491 10.4084 -2.82358 -5.49605 1.13538 +321 2 3.0796 11.6369 9.01245 -0.492053 5.16034 -4.32733 +322 1 11.1043 10.8166 1.33994 -11.5702 -13.9866 8.70354 +323 2 11.3928 11.6085 0.903197 7.06397 14.5046 -5.44138 +324 2 10.1649 10.7312 1.10986 7.36828 -2.13735 3.91294 +325 1 13.1846 7.09882 12.8318 18.6724 6.28095 -0.937746 +326 2 14.1536 6.98642 12.9472 -16.4658 1.64828 -3.93553 +327 2 12.8311 6.20921 12.7949 -4.05904 -6.33012 1.01947 +328 1 9.62724 1.89857 0.976269 -5.84048 -4.71512 -19.854 +329 2 8.85605 1.47112 0.556627 5.981 10.7585 7.84687 +330 2 10.1714 2.22507 0.238723 -1.51496 -2.73206 9.47681 +331 1 10.5937 13.5214 4.66199 3.2234 0.0339744 -7.62843 +332 2 11.4486 13.114 4.51461 3.39436 -8.72009 -0.849353 +333 2 10.7191 13.8974 5.52846 -5.55452 9.94363 9.85641 +334 1 14.3279 1.73837 10.9221 -6.80645 -20.6925 1.76137 +335 2 15.1234 1.41881 10.4767 1.97621 6.90305 1.731 +336 2 14.3743 2.69243 10.9875 9.24527 6.91542 -4.56959 +337 1 14.6348 12.3447 11.7069 0.143663 -8.85162 -7.69369 +338 2 15.3924 12.4169 11.1267 15.8185 6.23005 6.53749 +339 2 13.9779 12.0599 11.0796 -19.2308 -4.32411 1.56042 +340 1 8.24345 5.06862 9.81236 -2.43519 -19.796 -15.4196 +341 2 7.42328 5.28077 10.2334 -12.2119 11.2175 13.6651 +342 2 8.03366 4.19231 9.43495 14.0834 8.03075 2.78805 +343 1 1.55958 16.8456 18.3509 0.293915 -24.903 24.1992 +344 2 1.74487 17.2231 17.5072 8.4457 6.47265 -18.7434 +345 2 1.95964 15.9468 18.3277 -12.6492 15.8955 -3.16542 +346 1 1.46885 17.2295 15.3261 -41.9231 18.9429 7.61422 +347 2 1.60163 18.0716 15.7975 2.88525 -7.29411 -7.90761 +348 2 0.471438 17.1304 15.2829 39.2238 -5.53287 -0.382895 +349 1 3.69895 5.65007 6.13962 5.67498 -13.7905 -4.71311 +350 2 3.08621 6.15365 6.67268 -1.79156 10.6243 5.04455 +351 2 4.29662 6.26435 5.6935 -4.62364 1.91275 -0.121461 +352 1 12.3686 9.4572 14.1916 2.50325 4.1373 0.835901 +353 2 12.6534 8.64397 13.7789 7.43403 -8.19142 -7.10693 +354 2 12.2431 9.18714 15.1032 -3.68368 1.41273 6.14038 +355 1 4.03462 15.2828 6.91278 -20.0144 -6.90546 3.84648 +356 2 3.57361 16.022 6.48562 4.0204 -1.30953 4.99773 +357 2 4.97214 15.427 6.85986 17.0804 8.85667 -5.89205 +358 1 0.596937 8.57007 14.913 -2.82207 -2.34568 11.0967 +359 2 0.589839 9.51288 15.1099 0.171131 2.88226 -3.41975 +360 2 1.22453 8.45469 14.2015 6.96836 3.95738 -3.73783 +361 1 12.9772 8.31295 10.3135 -4.52981 3.4147 9.81026 +362 2 13.748 7.88649 9.95158 7.10588 -4.96512 -13.4998 +363 2 13.0418 8.05063 11.2408 -7.87478 3.04011 -0.538852 +364 1 15.3081 7.67138 3.5266 23.4653 37.2808 -10.5735 +365 2 14.5495 7.31548 3.08478 -13.5361 -20.5278 3.76808 +366 2 15.7097 7.21489 4.26906 -13.5998 -13.5183 6.32814 +367 1 17.3139 6.67347 0.0519528 8.75828 -11.5188 0.32751 +368 2 16.922 5.81479 0.236083 -1.36263 0.235584 3.31968 +369 2 16.5542 7.20912 18.4844 -8.7655 12.4237 -8.09845 +370 1 8.86065 6.91878 7.81669 10.1209 17.2302 -14.0365 +371 2 9.80786 7.17641 7.77744 -16.0922 -4.42618 4.57681 +372 2 8.74795 6.24147 8.48473 3.77983 -6.9476 8.96536 +373 1 12.3541 0.627989 1.20673 7.59332 -4.64776 2.86492 +374 2 13.2579 0.528374 1.53727 -3.51801 6.0046 2.76074 +375 2 12.2851 18.632 0.498856 -2.53947 0.382583 -4.14536 +376 1 5.64549 15.138 14.5235 -4.10456 -30.421 5.78959 +377 2 4.73353 15.1769 14.8501 2.72532 6.49481 -6.12593 +378 2 5.9656 16.0086 14.3294 1.76375 18.5631 -6.42604 +379 1 3.85619 6.49135 1.72458 1.34418 -5.76632 6.1851 +380 2 3.4082 7.28863 1.44351 -4.61345 8.91678 -8.73454 +381 2 4.04036 6.67595 2.65567 -1.04596 -4.79787 -3.17499 +382 1 3.88128 11.6181 12.3021 -8.90147 -4.54474 -0.675722 +383 2 4.76839 11.88 12.5585 3.1774 6.51538 0.922611 +384 2 3.25574 12.2257 12.7332 9.80963 -6.2977 -1.14662 +385 1 5.41097 3.86243 15.8619 7.77498 -26.7447 2.47729 +386 2 6.19051 3.2555 15.8125 -22.34 13.8462 -4.82428 +387 2 5.75732 4.74289 15.8731 9.06733 16.771 0.375084 +388 1 14.4275 10.3077 4.42737 -15.4583 -1.2468 24.8449 +389 2 14.4136 9.7945 5.25584 5.65105 6.60384 -6.24763 +390 2 14.7139 9.69599 3.76155 7.16087 -8.52398 -12.4829 +391 1 7.87022 17.3652 9.18307 -6.55512 0.129027 -0.760847 +392 2 7.04604 17.5698 9.62158 -5.94597 -4.85201 9.5143 +393 2 7.92762 18.0395 8.50377 8.60962 -1.46955 -8.60251 +394 1 4.50919 14.4633 3.94747 -3.26277 6.69504 -13.1744 +395 2 4.44326 15.3745 4.23469 1.61374 7.68172 -2.63862 +396 2 4.73121 13.9745 4.72809 3.38773 -13.7326 11.5154 +397 1 14.2916 7.39166 15.7799 -19.0102 -0.643935 -4.97281 +398 2 15.227 7.28492 15.6956 21.3172 -2.59108 -3.06 +399 2 14.1661 7.73476 16.6606 0.966931 5.43289 9.36717 +400 1 2.93597 18.2496 1.90178 2.72474 -19.4407 -7.90163 +401 2 2.41137 17.5137 1.50762 13.3283 19.165 4.04527 +402 2 2.31568 18.912 2.18531 -12.4791 7.28301 8.56329 +403 1 7.97625 1.60842 4.55987 -20.0747 11.2227 -5.58284 +404 2 7.40672 2.18903 4.02942 -3.00667 -10.939 3.58357 +405 2 8.83426 1.86357 4.26417 23.6954 -1.42515 0.234182 +406 1 2.55973 14.139 17.7235 4.4947 4.4122 -3.81652 +407 2 1.9869 13.4419 18.0532 -4.8721 0.171095 2.94118 +408 2 3.45785 13.8729 17.9629 -0.333069 -3.9381 0.822902 +409 1 0.778432 1.72633 13.8806 -27.0748 -1.51039 10.7449 +410 2 0.840363 1.33642 14.7677 3.59517 6.80992 -7.55552 +411 2 18.4512 1.86919 13.7675 25.1129 -0.50251 -4.23703 +412 1 4.5218 18.6217 13.9311 -26.2208 4.76485 6.31935 +413 2 5.44026 18.4597 14.0857 18.6112 -6.32709 -3.49173 +414 2 4.08533 18.4032 14.7706 3.39103 3.57256 -5.13956 +415 1 7.0966 0.590139 18.3583 40.0867 -7.03194 -16.485 +416 2 7.43029 0.218977 17.5038 -14.1267 7.45313 19.238 +417 2 6.15491 0.497007 18.3797 -17.6926 4.43938 -0.268226 +418 1 16.0869 18.4184 14.0665 12.1783 12.0602 19.9903 +419 2 15.2602 18.093 13.7757 -22.8702 -12.1677 -15.3509 +420 2 15.9307 18.6351 14.9998 9.22594 -1.26981 -3.76068 +421 1 10.0615 4.5254 16.2644 17.4965 34.4304 -0.599412 +422 2 10.952 4.96419 16.2693 -15.2122 -21.3498 0.578373 +423 2 10.2001 3.58581 16.3272 5.99955 -12.591 -1.94777 +424 1 15.8874 17.8488 4.44366 26.9944 -8.8935 -8.85545 +425 2 16.3583 18.6921 4.41154 0.375294 -2.3726 2.41747 +426 2 14.9936 18.0388 4.65191 -27.7242 10.9512 11.1951 +427 1 6.97313 17.3837 13.7492 -14.8371 0.980348 6.17816 +428 2 7.33935 17.5289 14.6184 6.46616 5.40365 9.01508 +429 2 7.73032 17.2786 13.1826 8.79779 -2.98362 -9.94394 +430 1 13.295 6.50203 6.69495 9.53809 17.2257 -14.0038 +431 2 14.0496 7.07319 6.46986 -0.499105 -8.31015 13.7378 +432 2 12.8724 6.42857 5.83749 -8.85952 -9.05901 -3.70628 +433 1 7.73318 2.36184 9.23357 -5.82839 -0.191385 25.6357 +434 2 7.13515 2.2598 10.0003 13.8878 3.27143 -3.38814 +435 2 7.19146 2.08044 8.50905 -8.01798 -3.82737 -18.8349 +436 1 15.1683 14.8678 13.6621 4.32457 -5.24538 6.92634 +437 2 15.0117 15.191 14.5524 1.96766 -1.10504 5.54809 +438 2 14.4461 15.1877 13.1369 -6.78809 4.58671 -11.3713 +439 1 9.33811 8.31525 3.72912 -3.71623 14.6513 -1.76526 +440 2 10.1422 8.72537 4.07444 1.32163 -4.04075 -0.39549 +441 2 9.3744 7.3721 3.88081 4.66337 -7.69389 3.46587 +442 1 17.73 13.5264 16.4473 3.62887 -10.5665 6.33517 +443 2 16.8053 13.2497 16.375 1.67263 6.91521 -3.1024 +444 2 17.8249 14.3621 15.9879 -5.28625 7.64018 -4.86126 +445 1 4.99014 10.6392 2.69296 -11.8842 10.0017 7.67541 +446 2 5.62836 10.2105 3.25699 12.1385 -6.17254 3.53336 +447 2 4.64978 11.3543 3.2597 0.304061 -9.29163 -9.90123 +448 1 3.7356 8.34279 10.2382 -0.81373 18.9096 -12.0232 +449 2 3.86658 9.26506 9.94102 0.197912 -10.4595 0.115104 +450 2 3.49052 8.44407 11.1547 0.601112 -5.92985 11.4704 +451 1 16.0428 7.05286 6.2029 -10.6575 13.2953 -5.82849 +452 2 16.855 7.48535 6.46978 4.82485 2.35526 4.73173 +453 2 16.1613 6.12013 6.32007 7.39497 -13.7867 -3.51418 +454 1 15.1327 7.05037 9.11575 3.87713 -5.32828 6.40762 +455 2 15.8626 7.43029 9.61535 2.26476 1.25298 1.00848 +456 2 15.1324 7.53151 8.29313 -1.46271 6.60183 -11.5025 +457 1 6.39444 13.0666 12.8402 5.00849 -18.9174 -4.31708 +458 2 7.14138 12.6166 13.2588 -1.3728 0.0732389 -8.28768 +459 2 6.25233 13.8543 13.3456 -7.70591 16.466 12.3405 +460 1 12.1285 4.48598 13.0882 -38.1563 -9.245 -8.92104 +461 2 12.05 4.67155 14.023 12.2106 4.08095 10.8898 +462 2 11.2367 4.10453 12.8753 29.4794 5.44987 -0.890783 +463 1 11.348 8.18475 7.8598 -17.4059 7.12531 -10.6431 +464 2 12.038 7.63484 7.48501 10.4081 -6.60064 5.31237 +465 2 11.4756 8.28116 8.80352 11.9689 -3.04214 7.26146 +466 1 17.1922 10.8074 7.44155 -25.4203 14.6985 18.6261 +467 2 17.9197 10.2075 7.32737 10.9985 -8.38668 -11.5183 +468 2 17.0629 11.3797 6.67504 9.09121 -1.65978 -2.87918 +469 1 5.25169 18.1248 11.0507 12.0648 3.50666 -3.83562 +470 2 4.62743 17.897 11.7414 -1.9785 0.423337 4.7613 +471 2 4.73712 18.33 10.2687 -7.94827 -3.02158 -5.48025 +472 1 7.57794 17.5568 1.83513 6.93874 5.3114 -35.8297 +473 2 7.86736 16.7596 1.34843 -3.99011 9.3379 11.9664 +474 2 7.57256 18.2518 1.1344 -7.92946 -12.1924 16.8763 +475 1 1.91036 12.9101 13.6013 -3.96045 -14.8375 -19.2024 +476 2 1.39392 12.2568 14.0828 0.939403 1.79227 7.54842 +477 2 2.06766 13.6568 14.1634 3.48639 14.3121 10.7878 +478 1 9.68075 6.78169 14.8149 2.18853 -17.0585 -1.56943 +479 2 9.86519 5.84438 15.0146 -5.66436 10.7434 4.7021 +480 2 10.1054 6.93436 13.9655 -4.91522 4.89205 -3.51643 +481 1 15.2489 4.31705 10.7696 10.3165 19.1063 17.7081 +482 2 16.2033 4.28261 10.8841 1.13215 -16.3849 -6.84609 +483 2 15.045 4.99149 11.4324 -10.9146 -3.35461 -8.40134 +484 1 11.2157 6.13912 0.184288 19.0347 18.6277 4.4365 +485 2 11.389 5.28379 -0.213728 -9.30505 -7.86745 -0.661886 +486 2 10.2971 6.41228 18.7766 -10.0409 -9.92482 -6.17869 +487 1 0.119384 11.3453 15.1007 -14.3711 11.1071 -8.9459 +488 2 18.1083 11.5338 14.3994 8.87914 -3.31428 2.86805 +489 2 18.675 12.1405 15.6491 -0.376992 -6.76779 4.41889 +490 1 7.06293 9.20482 7.26347 16.9728 2.93661 -2.33726 +491 2 6.45996 8.52415 7.5376 -12.746 -11.932 7.1182 +492 2 7.92776 8.76781 7.32981 -4.82181 7.51802 -3.03552 +493 1 18.3776 15.4097 12.3582 -11.3114 -7.16639 4.00893 +494 2 0.682756 15.4096 12.2525 13.0982 4.14044 -6.05458 +495 2 17.9899 15.7976 11.566 2.11158 0.973908 -1.02825 +496 1 16.5513 4.36706 5.24159 -5.09045 5.24791 -23.7034 +497 2 16.6166 4.33687 6.19466 14.1446 -5.59224 10.5876 +498 2 17.404 4.59908 4.81371 -8.86364 -4.80736 14.9956 +499 1 17.7417 3.09647 10.7341 0.291254 -10.6186 -10.4582 +500 2 0.00513181 3.34109 10.9087 8.18655 7.52385 6.55564 +501 2 17.8253 2.23203 10.2933 -8.67083 8.1401 4.47273 +502 1 12.2919 0.0227122 10.1361 2.29147 -28.3523 -7.04943 +503 2 11.4789 0.3695 10.4906 -11.5623 8.87459 2.77288 +504 2 12.9485 0.705533 10.1424 9.22066 20.6222 4.35768 +505 1 10.3653 9.79669 12.372 -8.95345 -3.20907 -9.5203 +506 2 11.0695 9.83133 13.0162 9.21286 -1.60231 7.36796 +507 2 10.2442 8.85709 12.1552 0.446892 6.98856 4.38647 +508 1 0.537603 2.83987 7.02256 -3.09155 -21.8169 -17.6677 +509 2 0.689112 3.48917 7.69969 6.81735 5.32415 12.4887 +510 2 0.745143 1.97019 7.39814 0.967775 11.9311 3.78775 +511 1 0.407687 15.2844 6.91114 -10.1505 12.0239 22.1786 +512 2 0.487576 14.9005 7.81264 0.770838 8.15944 -16.8401 +513 2 0.754028 14.6482 6.29753 4.41733 -17.9374 -4.37366 +514 1 17.0108 7.01877 15.2726 9.75856 -4.98107 -8.16179 +515 2 17.7945 7.53845 15.0774 -4.62906 13.8031 -0.900924 +516 2 17.4019 6.14594 15.3485 -8.43732 -9.20439 7.91006 +517 1 9.04118 12.4266 8.12126 20.8625 -13.8276 -21.4288 +518 2 9.31201 11.8186 7.41014 14.8696 5.22508 9.07579 +519 2 8.11227 12.3461 8.03152 -32.7632 10.2849 9.08461 +520 1 1.26557 1.8876 3.02782 9.65045 8.01813 1.36118 +521 2 0.751817 2.27104 2.32199 -7.08934 -1.28284 -8.05339 +522 2 1.78864 2.63408 3.35807 -1.4257 -10.3882 4.86199 +523 1 4.12138 15.1091 9.73113 11.5132 -2.98862 0.0844269 +524 2 4.08037 15.3711 8.80771 -6.64563 1.38763 -1.25331 +525 2 5.02377 14.7713 9.82789 -5.61093 0.302526 6.22582 +526 1 7.21558 2.18454 14.596 -3.30246 -13.7461 5.2135 +527 2 6.95017 1.78255 13.7582 4.82488 2.3919 4.06302 +528 2 7.77929 2.92256 14.3836 3.82883 9.51482 -6.38734 +529 1 18.5827 14.6796 2.1698 -24.3208 -2.36026 -2.50397 +530 2 0.827663 15.0286 2.10654 6.16868 9.29818 1.18622 +531 2 17.9285 15.4101 2.10387 15.0339 -9.50868 3.05979 +532 1 9.96457 2.76705 12.9307 -6.0306 9.60441 -0.715471 +533 2 9.81933 2.16697 12.1996 2.81266 -10.505 -5.71659 +534 2 9.23975 3.40361 12.8511 1.73763 -0.77134 6.44595 +535 1 2.86173 8.92609 13.0404 7.24036 -2.57601 -2.21085 +536 2 3.32754 9.76259 12.8684 -5.41233 -1.95407 1.34833 +537 2 3.53569 8.30272 13.3558 -0.616664 3.71534 -0.977901 +538 1 3.21505 8.40688 3.66968 15.7234 22.1036 -19.602 +539 2 3.76887 9.07341 3.20135 -16.7118 -11.852 2.14794 +540 2 3.39007 8.60458 4.57891 -0.363765 -1.98929 20.9454 +541 1 5.60252 7.19004 8.53175 5.86958 -4.86959 9.5617 +542 2 5.84506 6.27445 8.70563 -2.01066 -2.63063 -12.6146 +543 2 5.1548 7.42343 9.34691 -7.32508 9.6882 0.185442 +544 1 14.8904 1.34267 1.9851 -2.44355 -11.2972 17.4528 +545 2 14.6303 2.11535 2.51846 2.91157 0.487188 -15.3266 +546 2 15.025 1.53806 1.05778 2.17575 14.4946 -4.76666 +547 1 8.30348 15.1948 0.839181 1.62975 3.11742 -15.2912 +548 2 9.05101 15.1086 1.44328 -1.42893 -5.28711 5.64984 +549 2 7.54504 14.6965 1.17349 5.50357 -4.17517 7.24781 +550 1 15.6062 1.34647 7.22998 12.9139 6.24135 5.03718 +551 2 15.0343 0.764422 6.7383 -10.7397 -5.17 -5.22658 +552 2 15.1371 2.18077 7.35367 -5.42005 -2.19365 2.65732 +553 1 4.96367 13.0608 18.5175 -8.25637 -3.65043 -17.7207 +554 2 5.34878 13.2483 0.722802 8.16177 0.261597 12.4464 +555 2 5.65153 13.2431 17.8644 -2.22894 4.298 3.81358 +556 1 15.3614 8.50445 18.1376 -9.02232 -8.38547 12.9254 +557 2 15.7319 9.00583 17.4156 5.20151 10.9324 -8.24127 +558 2 15.1687 9.14311 0.198883 4.58141 -1.82544 -4.44514 +559 1 12.0904 3.05083 18.3558 5.74067 -18.2993 3.78166 +560 2 12.2947 2.48128 0.458355 -7.48955 9.04159 13.408 +561 2 12.4465 2.47277 17.6781 -3.43414 10.0689 -17.6065 +562 1 13.2065 12.6801 5.18634 5.84251 -1.21193 6.01102 +563 2 13.6832 11.8727 4.98831 0.374712 -2.89081 -11.6293 +564 2 13.5252 12.8732 6.07674 -9.12379 3.52213 -1.02632 +565 1 6.05538 7.10808 0.0622478 7.64822 4.54905 2.96407 +566 2 5.99209 8.01824 19.0386 -2.92171 -4.08442 -8.95141 +567 2 5.21644 6.68693 0.272307 -1.20959 2.69213 5.93171 +568 1 17.7218 15.9656 14.99 27.5308 -15.6865 18.0891 +569 2 16.9388 16.4863 15.1181 -14.3434 5.91292 -14.0866 +570 2 17.911 15.7342 14.0701 -14.8265 10.2647 -3.26624 +571 1 13.1712 0.994875 16.5867 2.52549 -1.56274 -3.32645 +572 2 14.0875 0.750433 16.7652 2.07951 0.899412 2.60052 +573 2 12.7522 0.177983 16.2988 -0.931869 -3.47373 4.92885 +574 1 11.0723 14.6005 7.26575 -13.1255 -10.0571 4.65979 +575 2 10.3507 14.0428 7.62559 10.576 8.81418 -2.61622 +576 2 11.902 14.168 7.50495 -4.44994 -4.81764 -1.49609 +577 1 17.5239 8.59779 2.09084 -4.28833 -20.5194 -15.9758 +578 2 16.6824 8.33187 2.48237 1.37862 7.81735 4.46419 +579 2 17.5834 7.99355 1.32242 5.93631 9.11716 13.4418 +580 1 12.3581 7.93946 1.97566 -1.89696 -6.27914 -3.50436 +581 2 11.9505 8.79823 2.04436 -0.86405 10.6038 1.69948 +582 2 11.9097 7.53044 1.22383 5.98844 -6.29912 5.7943 +583 1 11.9176 14.6241 10.3724 -2.87076 17.8373 18.3305 +584 2 12.1889 13.9308 9.80998 14.0474 -22.5763 -16.4958 +585 2 11.017 14.792 10.1004 -10.4734 4.60408 5.02203 +586 1 6.86179 7.0045 15.5825 0.298402 -7.5032 -11.9192 +587 2 7.72978 7.09161 15.1865 4.58892 -5.83629 -5.839 +588 2 6.8806 7.68521 16.2363 -7.39186 11.3873 16.6815 +589 1 8.0061 4.66768 13.4643 -26.1906 -20.4665 -29.1007 +590 2 7.40104 4.82554 12.6933 13.2028 -5.13213 23.0799 +591 2 8.47723 5.469 13.5831 13.4856 24.6751 2.60837 +592 1 13.392 12.1682 14.29 6.21681 3.24263 -1.56593 +593 2 13.3744 11.2127 14.1772 -7.69192 -2.80185 3.02585 +594 2 13.9051 12.489 13.5384 -1.40129 2.2659 -1.62493 +595 1 14.7806 9.45441 7.28093 -11.5532 20.7697 15.955 +596 2 15.4984 10.0862 7.4818 -3.61589 -14.7511 -6.73617 +597 2 14.0294 9.75726 7.82532 9.94729 -6.45384 -10.5104 +598 1 12.6903 16.9959 3.11063 13.9021 -20.0527 -1.11079 +599 2 13.0479 17.2495 3.95961 -1.86196 6.25123 9.18833 +600 2 12.0243 17.6278 2.88206 -13.6174 14.7021 -2.85583 +601 1 1.14933 7.13689 17.4392 -10.8552 -5.82346 1.42608 +602 2 0.254324 6.85235 17.6903 1.68989 10.0465 1.1249 +603 2 1.04814 7.64429 16.6282 0.816381 -0.80389 -4.56811 +604 1 12.8311 5.11146 15.6849 -17.6595 -4.33947 -1.38663 +605 2 13.5036 4.46543 15.459 7.94947 -3.95791 3.77703 +606 2 13.2565 5.97185 15.6774 7.16 2.75079 -1.64654 +607 1 2.47852 3.39671 5.05511 -15.8601 -20.9034 -7.20071 +608 2 1.89248 3.0773 5.76599 4.829 7.89548 -3.4806 +609 2 3.06433 4.04634 5.42706 4.34046 14.9349 7.02505 +610 1 8.31182 11.2281 13.4853 12.2486 -8.92827 -7.03776 +611 2 8.34382 10.988 14.3869 -16.2376 0.866389 37.005 +612 2 9.12412 10.7865 13.2309 -0.249665 2.67206 -26.3927 +613 1 12.9087 1.417 13.3166 0.0274524 -25.355 19.3096 +614 2 13.4801 1.21198 12.5759 3.32243 8.60198 -10.444 +615 2 12.4274 2.20637 13.1188 -4.80778 18.3372 -7.59901 +616 1 6.3961 13.6531 2.14242 21.3539 -7.72513 -19.5528 +617 2 5.86296 14.1246 2.76583 -10.9825 4.85946 19.6126 +618 2 7.0399 13.1177 2.63436 -6.77103 3.35988 1.82582 +619 1 15.9312 6.57282 12.7577 9.39393 9.94387 -6.4398 +620 2 16.4454 7.11896 12.1297 -10.141 -7.43973 7.84454 +621 2 16.2972 6.7745 13.6327 -0.398164 -4.05689 -3.4507 +622 1 16.8338 0.714138 9.59622 -4.58014 7.56344 -3.36861 +623 2 16.786 18.4184 9.78234 2.45796 -8.84878 0.088887 +624 2 16.3762 0.83732 8.75167 2.21028 0.792186 -0.559114 +625 1 6.14371 11.7069 8.36929 2.81279 3.26044 -4.5559 +626 2 5.21452 11.6136 8.62066 2.93526 -5.28935 1.80511 +627 2 6.46143 10.8412 8.07651 -3.38714 0.356066 2.25694 +628 1 2.85881 8.67012 0.388915 2.79689 11.0982 14.7719 +629 2 2.20875 8.30366 18.4701 -9.93413 -28.5632 -26.9968 +630 2 2.30006 9.32334 0.801848 8.26615 13.7996 15.8107 +631 1 10.1321 10.4555 6.53489 -7.45039 0.329373 10.0784 +632 2 10.6046 9.83719 7.10845 -0.190248 -0.487921 -4.0191 +633 2 10.6634 10.5725 5.74842 5.176 -1.34798 -7.09506 +634 1 6.75471 15.7115 6.57125 -11.9312 -6.35937 -2.57899 +635 2 7.17812 16.0056 7.37746 4.55156 8.98271 2.0062 +636 2 6.84858 16.4009 5.89838 10.4548 -3.40393 4.92981 +637 1 6.44667 13.1112 5.62964 2.65073 6.32881 3.74437 +638 2 6.67596 13.9769 6.00675 -0.0120675 -6.80172 -3.34498 +639 2 5.96115 12.6448 6.31389 0.45756 -2.92263 2.45964 +640 1 16.7937 12.5442 9.80018 5.98989 11.7335 -8.95445 +641 2 16.9887 11.9765 9.05284 -0.702856 -11.4944 -2.64553 +642 2 17.0098 13.4184 9.45025 -4.64512 -2.35242 9.41775 +643 1 6.08081 2.94855 2.81201 5.81343 6.87552 13.2918 +644 2 6.21399 3.88965 2.59312 -1.02666 -12.0092 -4.68113 +645 2 5.77459 2.45978 2.03916 -1.91968 5.61369 -5.09877 +646 1 10.8797 3.26448 3.27711 -5.41025 -2.45564 -6.20574 +647 2 10.301 3.99846 3.49319 -0.0844139 2.78359 4.78679 +648 2 10.5123 2.93026 2.45079 3.61554 -5.12824 0.569032 +ITEM: TIMESTEP +40 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.73557 7.01799 17.9607 21.964 -6.69295 -3.41675 +2 2 7.837 6.97936 18.244 -22.923 1.28376 8.03757 +3 2 8.84363 6.25859 17.3828 1.27689 0.0651665 -4.69765 +4 1 18.6647 8.30209 6.83035 -0.644058 3.99523 -48.5507 +5 2 0.211245 8.12789 5.86514 -9.60619 8.91963 25.083 +6 2 0.465598 7.58914 7.26037 9.90688 -14.2806 22.1152 +7 1 8.44495 18.6364 6.8238 -19.0399 -0.344231 6.51496 +8 2 9.34052 0.200584 6.61788 21.6732 5.78047 -4.99449 +9 2 7.92466 0.711623 6.44684 1.16681 0.183702 -1.11302 +10 1 6.56005 1.80411 11.6838 -38.7214 4.43655 14.793 +11 2 5.75321 2.272 12.0538 30.5925 -16.6996 -9.96133 +12 2 6.22943 0.898268 11.5156 6.32845 11.0599 0.0206858 +13 1 7.08366 5.68816 2.38617 22.7225 -30.9477 -12.475 +14 2 6.58152 6.21056 2.95839 -27.8787 23.1579 37.4024 +15 2 6.84697 6.04683 1.54845 0.038941 9.08719 -25.9535 +16 1 16.22 10.2137 16.0864 41.4588 -5.13522 6.23048 +17 2 17.1921 10.3703 16.208 -28.8473 -8.8876 -9.54756 +18 2 15.8271 11.0171 16.4051 -13.971 12.6367 2.51598 +19 1 10.6448 14.9575 2.33364 6.27542 19.2207 -0.856148 +20 2 10.5562 14.6084 3.22703 2.40752 -4.54155 -3.02292 +21 2 11.1101 15.8129 2.46012 -8.85901 -18.4002 -3.84051 +22 1 17.1611 8.2532 10.553 -11.2529 -0.0170881 12.6501 +23 2 16.8393 8.94572 11.1538 -1.12797 -5.57792 -5.31501 +24 2 17.9446 8.61302 10.1436 10.8511 4.56282 -2.94704 +25 1 14.7728 15.897 16.3892 -19.7826 14.9663 0.46496 +26 2 13.8411 16.2137 16.4626 21.4068 -5.53606 -7.5515 +27 2 14.9622 15.5552 17.2653 -0.403084 -10.0705 4.87845 +28 1 12.136 13.4022 0.475357 -11.3959 -2.02194 -12.751 +29 2 11.9408 13.3873 18.1673 8.9331 -2.53085 4.8524 +30 2 11.4037 13.9022 0.849725 6.62825 2.84238 11.8203 +31 1 9.29338 5.44787 4.01163 24.6694 12.616 -29.9837 +32 2 8.80858 5.1972 4.76287 -21.098 -14.9153 34.0625 +33 2 8.63435 5.49966 3.31701 -4.42724 -1.21089 -8.36553 +34 1 1.79376 4.18976 11.6282 4.46954 -46.7602 7.51249 +35 2 1.70048 5.09501 11.8512 -4.37305 32.1952 10.6933 +36 2 2.09275 3.70286 12.4334 -4.9207 12.4729 -20.4441 +37 1 2.01732 6.80615 8.34226 1.64844 10.8358 -0.647304 +38 2 2.37448 7.3471 9.0762 -2.77819 -13.6149 -8.9692 +39 2 1.92609 5.89421 8.65385 1.80745 6.26657 1.98394 +40 1 5.38901 4.42498 7.95307 14.0474 9.0477 19.097 +41 2 5.49608 3.48465 7.79451 -4.39314 -7.26091 -3.25333 +42 2 4.79389 4.80722 7.31869 -10.598 0.276841 -18.5158 +43 1 3.29732 2.94293 17.5086 17.2208 -30.0882 -17.6092 +44 2 4.02601 3.30007 16.978 -4.8938 2.423 1.99348 +45 2 2.81217 3.66256 17.8655 -12.7512 26.7583 13.4218 +46 1 7.44366 5.31542 6.10005 -2.04578 -15.3999 -38.6663 +47 2 8.07874 5.97061 6.33436 13.5587 20.8049 21.0336 +48 2 6.95124 5.08125 6.86821 -11.582 -6.53412 22.3247 +49 1 9.78574 7.01841 12.0035 -14.224 -5.31732 -23.9819 +50 2 10.3573 6.41663 11.5027 -2.93892 5.75769 9.08141 +51 2 9.02058 7.16943 11.392 19.9248 1.87014 17.2782 +52 1 14.0222 3.60384 8.07347 21.1656 -3.6634 36.3987 +53 2 13.9951 4.24089 7.37961 -2.65045 17.7741 -13.562 +54 2 14.5465 4.02482 8.8088 -19.0215 -13.1146 -21.9867 +55 1 4.60432 17.1743 3.97092 -4.17058 -8.50894 9.4345 +56 2 5.51528 17.3741 4.10719 24.7317 1.00316 8.45766 +57 2 4.31895 17.8257 3.35422 -16.1123 9.67587 -20.1592 +58 1 16.4938 16.6102 10.1803 -22.58 10.2442 28.8776 +59 2 15.6971 16.8258 10.7464 27.0105 -10.9286 -19.8859 +60 2 16.1827 15.9878 9.51957 -5.57273 -0.00226425 -4.98818 +61 1 1.9645 4.84741 0.368078 -14.0488 -12.8308 -13.2388 +62 2 2.69854 5.15593 0.879033 14.2396 9.43314 15.7095 +63 2 1.5724 5.64147 0.000503254 -0.0595591 4.00938 -5.12573 +64 1 11.6747 13.3071 16.3147 -7.05005 22.2307 18.0491 +65 2 11.0866 12.5598 16.3919 -3.1788 -17.5748 -3.92498 +66 2 12.2584 13.1709 15.5748 2.75178 -8.36686 -13.1919 +67 1 10.131 11.038 16.8986 -21.0542 26.9507 -1.58256 +68 2 10.4848 10.1706 16.8573 15.2828 -28.4038 0.505132 +69 2 9.17797 10.924 16.7712 4.48065 0.743861 -0.190366 +70 1 11.7352 17.4666 13.4614 -1.07936 25.6776 8.56908 +71 2 12.4835 17.2209 12.9203 3.02318 -9.35187 -8.63799 +72 2 11.8077 18.4454 13.5145 -0.798306 -16.7366 -1.43427 +73 1 6.39395 9.3313 12.2301 16.0138 21.1557 17.835 +74 2 6.78657 8.92292 11.474 4.59605 -10.3711 -18.9433 +75 2 7.12055 9.89522 12.5742 -21.4515 -7.31443 1.84288 +76 1 16.2436 12.8045 2.69297 9.19112 6.28957 -1.09055 +77 2 17.1119 13.1995 2.45018 -21.0084 -1.00278 4.98407 +78 2 15.5746 13.5129 2.79044 13.212 -4.74068 -2.98151 +79 1 0.66547 12.6008 5.89246 44.3801 0.278469 12.8923 +80 2 0.944588 12.4662 4.9918 4.15776 -1.70344 -11.3497 +81 2 18.3844 12.6561 5.85431 -44.3715 7.63264 -5.03051 +82 1 5.23201 16.4301 18.4413 -23.1671 11.3407 -2.74477 +83 2 5.81563 15.7669 18.0873 14.8521 -9.88299 1.40517 +84 2 5.51268 16.7513 0.656182 8.57816 -5.72834 2.04059 +85 1 0.568352 7.66823 4.13077 -28.9792 -20.0076 22.3714 +86 2 18.6051 8.03762 3.49503 -7.9612 4.34402 -11.87 +87 2 1.4037 8.01472 3.91532 39.463 15.435 -13.2826 +88 1 3.11888 8.95318 6.49662 60.4725 2.42495 -6.82714 +89 2 3.7308 8.46704 7.08062 -7.96075 9.2896 -8.18079 +90 2 2.27986 8.68504 6.76207 -50.4171 -10.8396 15.4956 +91 1 7.30368 10.3509 16.2473 20.2996 0.0228567 -17.1566 +92 2 6.66358 10.504 15.5564 -7.99994 0.888183 -0.524161 +93 2 6.82737 10.217 17.0566 -12.2765 1.21271 14.6854 +94 1 11.12 1.01485 5.00375 -0.0102216 2.84952 14.1843 +95 2 11.0857 1.87302 4.56078 2.3673 -3.0702 -4.20032 +96 2 10.7324 0.367128 4.41621 -3.73217 -2.39612 -13.1961 +97 1 4.37027 2.7904 13.2033 3.18584 17.5115 -8.99997 +98 2 4.79356 3.08499 14.0007 6.25053 15.0735 9.59097 +99 2 4.18046 1.89747 13.4272 -8.57413 -32.1756 -2.785 +100 1 8.40183 10.1302 1.81819 -11.3119 21.1596 -20.1509 +101 2 8.22596 10.8234 2.46526 3.55036 0.443395 1.34914 +102 2 8.74004 9.40086 2.30376 11.7587 -22.7948 15.5041 +103 1 10.4641 1.71908 15.5611 14.2583 -4.22402 3.33599 +104 2 11.4066 1.52258 15.371 -17.8532 5.60176 1.9802 +105 2 10.08 2.13518 14.7824 5.57904 -1.0897 -7.54918 +106 1 2.70316 12.9014 7.80195 3.19617 10.9991 1.8073 +107 2 3.3212 13.5754 7.49282 0.460726 -0.40643 1.73206 +108 2 2.13336 12.7538 7.04495 -5.07282 -6.75217 -1.11681 +109 1 3.70861 11.6625 5.14703 20.6482 18.5599 0.117703 +110 2 3.55555 10.8287 5.56068 -6.18613 -18.2271 10.4705 +111 2 3.04771 11.7826 4.47739 -15.5561 1.61657 -8.41129 +112 1 6.75631 14.4548 16.9127 8.94674 -1.78931 -0.924301 +113 2 7.71443 14.3361 16.9267 -6.94418 4.38523 0.882829 +114 2 6.52635 14.6721 16.0018 -2.96874 0.297136 0.835917 +115 1 14.1768 14.5549 3.37546 -9.20747 -5.25648 5.53536 +116 2 13.5738 15.2994 3.18581 6.88801 -12.7747 3.05988 +117 2 13.7349 13.9262 3.9882 4.46288 16.3838 -11.0193 +118 1 8.36945 18.1316 16.043 -50.6417 14.5597 -0.377943 +119 2 8.83326 17.39 16.374 32.1095 -21.5179 4.54953 +120 2 8.87194 0.178112 15.6264 24.4627 6.71878 1.23367 +121 1 4.74402 1.66109 4.92978 -19.7446 -31.5867 36.4561 +122 2 3.83516 1.95374 4.92736 -8.28526 7.01041 1.88485 +123 2 5.14187 2.10852 4.23181 25.7722 28.9669 -41.4039 +124 1 15.0327 12.6922 16.4463 -14.1895 -13.4373 -36.9651 +125 2 14.5853 13.1594 17.1179 -4.44761 17.5587 33.5367 +126 2 14.3173 12.6168 15.7704 28.0544 -5.79477 6.54775 +127 1 15.7455 18.4472 16.8494 -36.7721 -17.2537 -45.0168 +128 2 16.3082 18.5742 17.5575 42.6678 12.9246 46.9817 +129 2 15.6033 17.4929 16.845 -6.46687 1.33922 -4.84851 +130 1 1.19925 1.17644 16.5482 3.81725 -14.252 -17.647 +131 2 1.9494 1.76296 16.5282 11.9166 8.08174 5.38627 +132 2 0.720072 1.41993 17.3243 -10.8728 8.87917 17.8692 +133 1 18.1194 4.51517 15.8978 -9.12682 11.3324 16.5545 +134 2 18.3907 3.99589 15.1624 6.35448 -14.0345 -18.3092 +135 2 0.212938 4.54105 16.5062 3.72114 1.23331 1.72655 +136 1 12.2575 16.9791 16.1441 20.307 19.4582 -44.4732 +137 2 11.5756 16.5974 16.6415 -35.2707 -20.5418 23.5889 +138 2 11.9443 16.955 15.2053 9.79722 2.45701 21.3583 +139 1 15.9948 2.53341 18.0767 10.9381 -15.7258 5.9061 +140 2 15.4972 3.23449 18.4655 -6.78731 22.0319 12.1926 +141 2 15.8185 2.63494 17.1497 -1.81081 -2.22204 -19.1287 +142 1 6.71322 13.8205 10.2184 4.21251 -0.72826 -19.8354 +143 2 6.51318 13.5527 11.1172 -1.15071 -8.01371 4.0626 +144 2 6.63912 13.0526 9.6212 -3.83744 4.98216 12.3358 +145 1 10.1462 18.2988 2.74675 -22.097 -20.0437 20.6404 +146 2 10.3757 0.350258 2.15404 6.85623 19.4082 -18.4799 +147 2 9.18692 18.1396 2.61143 20.6475 -0.265938 -2.33946 +148 1 3.01179 17.7216 6.11391 16.3646 11.1083 -7.5066 +149 2 2.20644 17.7129 5.60578 -13.7656 -5.82691 -3.27397 +150 2 3.67703 17.9821 5.44947 -4.29715 -10.1951 11.4126 +151 1 12.5763 16.9057 8.00279 34.6812 6.34788 -19.799 +152 2 11.842 16.3339 7.82778 -18.535 -10.6459 7.52248 +153 2 12.4277 17.4882 8.74445 -13.6741 4.98834 7.73701 +154 1 14.8867 15.2801 8.21669 15.2681 -20.6133 -0.236719 +155 2 14.2473 15.9935 8.15265 -4.83203 2.49296 -8.82369 +156 2 15.4177 15.201 7.39136 -14.8487 16.0275 12.7595 +157 1 17.673 18.2386 0.358056 6.39969 9.72416 1.64776 +158 2 18.5627 17.8182 0.243387 -17.6184 17.4743 1.20562 +159 2 17.7074 0.56338 0.562155 11.394 -25.7036 -4.78753 +160 1 0.840605 10.4115 1.35744 37.4959 50.4012 -24.017 +161 2 0.0672579 9.99096 1.64345 -42.7842 -22.4511 10.6341 +162 2 0.58692 11.2092 0.808654 3.76922 -28.1369 19.051 +163 1 1.6843 12.2358 3.38047 -6.18426 -19.2714 -7.57792 +164 2 1.35621 11.4726 2.83119 9.65923 28.3457 4.48748 +165 2 1.68469 13.0653 2.87986 -2.69674 -10.3555 -4.68476 +166 1 0.583101 17.235 4.89274 4.80321 -10.1773 15.6529 +167 2 18.7212 18.0548 4.74777 -0.344371 -10.7938 17.6071 +168 2 0.457865 16.8228 5.79389 -3.26711 20.5272 -26.9728 +169 1 1.10197 0.931397 9.43269 -15.4399 -19.3078 -9.02275 +170 2 1.25908 0.443364 10.2575 0.781623 10.2528 -2.87546 +171 2 0.281175 0.525265 9.08113 16.3171 12.9297 7.39947 +172 1 16.7532 2.33623 13.2905 -6.48112 -9.83965 38.5991 +173 2 16.8955 2.59135 12.4052 6.16672 6.51778 -37.0535 +174 2 16.4416 1.41783 13.3009 4.47832 4.66932 -0.969858 +175 1 2.60624 15.8504 12.1681 -27.4943 19.2901 -21.9402 +176 2 3.16839 15.391 12.7532 19.3125 -15.6847 20.968 +177 2 2.92961 15.6774 11.278 4.5792 -4.36857 -3.32021 +178 1 16.4212 15.6424 6.03078 2.33398 -27.7044 12.4884 +179 2 17.3276 15.7008 6.32 9.77501 -6.8374 8.24343 +180 2 16.3266 16.4053 5.49767 -10.7497 25.3256 -21.0495 +181 1 5.80196 5.07502 11.792 -7.0375 5.38003 9.08436 +182 2 5.27256 5.62589 12.4097 12.9595 -6.51078 -10.685 +183 2 5.4277 4.18781 11.8485 -2.70068 5.27459 0.5345 +184 1 15.1729 4.86274 0.750774 -1.10571 10.9128 -33.6343 +185 2 15.2042 4.59535 1.64712 -4.27265 -9.78555 34.3171 +186 2 14.3466 5.34824 0.643665 4.19718 -3.49047 -1.12139 +187 1 16.3347 16.3636 2.07743 2.17372 -8.94604 27.567 +188 2 16.248 16.684 3.01162 -4.2135 -4.93901 -27.3972 +189 2 16.5997 17.1143 1.55727 4.53602 12.7734 -5.95158 +190 1 0.261441 4.84804 3.8055 -0.147017 -56.3045 13.8461 +191 2 0.475233 5.74211 3.84367 9.07909 56.4423 -0.745388 +192 2 0.927869 4.41838 4.37361 -9.48651 2.83213 -9.85838 +193 1 2.95802 15.0603 15.1014 -0.943114 0.172839 -27.3629 +194 2 2.80338 14.7297 15.9709 -3.98201 -9.31011 23.138 +195 2 2.36314 15.8122 15.0164 6.10514 4.60789 3.27938 +196 1 1.13815 14.652 9.54287 -29.9359 -26.3887 42.7894 +197 2 1.85794 14.2975 9.07203 33.137 -5.88851 -26.0645 +198 2 1.02375 13.9289 10.2175 -6.6715 26.0405 -18.8729 +199 1 13.5762 16.6063 11.5459 8.2131 -23.6119 0.793767 +200 2 13.33 17.296 10.9485 -9.11427 22.0857 -7.2987 +201 2 13.1805 15.8285 11.1175 -0.169415 1.89227 9.19008 +202 1 4.67714 1.46335 0.758621 16.4224 4.90719 -8.19047 +203 2 4.16601 2.0159 0.158762 -4.20381 1.9839 -0.0593356 +204 2 4.09672 0.7797 1.07984 -10.7002 -7.55851 6.47825 +205 1 1.4518 18.552 11.8572 6.2605 -28.7314 5.6203 +206 2 1.30143 0.363179 12.6934 -0.382356 1.32639 0.00372943 +207 2 1.68394 17.6168 12.0771 -1.80479 24.861 -1.36748 +208 1 11.5075 10.1198 4.02095 -18.4811 -8.70186 23.5865 +209 2 11.1917 10.5684 3.24759 -2.79925 6.67004 -19.1711 +210 2 12.4478 10.2129 4.02159 23.6747 0.339266 0.782627 +211 1 8.31226 12.1774 3.6909 13.3967 -8.0925 -50.6166 +212 2 9.08853 12.6634 3.95409 8.19758 6.83683 10.985 +213 2 7.73108 12.1161 4.40989 -25.5486 3.81511 42.2514 +214 1 14.4234 4.01167 3.27932 -6.39999 -0.808874 -15.5703 +215 2 15.0318 4.04602 4.01015 9.81333 2.6424 13.2185 +216 2 13.6949 4.61166 3.47516 -0.628596 -1.04819 4.76047 +217 1 5.60276 1.68001 7.51543 46.6974 51.3536 -38.165 +218 2 4.99884 1.09753 7.87161 -47.5789 -43.021 28.4342 +219 2 5.32972 1.80197 6.58421 6.01087 -7.11276 10.7862 +220 1 17.8847 1.08156 4.86879 -16.2479 -18.084 1.95698 +221 2 18.6198 1.37964 4.35055 14.6356 14.0949 -7.48199 +222 2 17.763 1.66674 5.61639 2.20316 6.60999 2.39214 +223 1 6.81142 9.41573 4.49306 -0.655622 0.432156 7.98772 +224 2 6.876 9.60924 5.45033 2.30801 -5.82211 -14.8304 +225 2 7.69814 9.2085 4.16641 0.21776 -0.211816 8.23149 +226 1 2.64622 14.9044 1.97705 -19.6169 -6.34757 32.4999 +227 2 3.24366 14.6749 2.7111 -2.05224 3.38495 -12.0409 +228 2 3.14951 14.9574 1.1885 18.3224 0.185563 -21.7099 +229 1 17.3026 12.9105 13.1506 5.97988 10.8617 -4.35729 +230 2 16.4943 13.3715 13.3508 -17.5214 -4.76439 4.13034 +231 2 17.8495 13.6655 12.9025 6.83053 -7.65676 -2.15198 +232 1 14.953 10.5544 1.38215 35.2581 29.1908 17.9973 +233 2 15.5812 11.2612 1.74238 -25.4064 -29.0048 -15.0024 +234 2 14.0938 10.9575 1.42777 -9.92862 1.12257 -1.65093 +235 1 5.7132 6.77849 4.57909 1.57168 19.8101 -12.7812 +236 2 6.1646 7.64962 4.62346 -11.1008 -12.4177 -0.29751 +237 2 6.30742 6.13992 4.97063 6.93571 -3.41618 11.3539 +238 1 8.02607 8.31482 10.3199 -6.67367 -6.11991 -5.1902 +239 2 8.5826 9.1064 10.2496 0.567217 -7.04018 -13.4516 +240 2 7.81744 7.96553 9.42928 8.80325 8.4252 13.4279 +241 1 13.463 18.3942 5.75922 18.2094 9.72717 -25.7917 +242 2 12.7029 0.253225 5.44631 -3.25776 3.56949 4.30859 +243 2 13.1448 17.7819 6.40042 -11.4028 -12.4364 22.7676 +244 1 0.157572 2.62906 0.18715 -8.27583 -44.4001 -2.30616 +245 2 17.9404 2.90438 -0.139246 -4.84787 10.7772 1.25282 +246 2 0.728557 3.33866 0.428035 8.4047 29.5908 2.16632 +247 1 12.7834 11.0467 9.74512 50.2143 -37.9981 33.2215 +248 2 11.9361 11.0491 9.39224 -54.8114 3.18277 -19.015 +249 2 12.8684 10.1188 10.1004 3.84712 25.3375 -10.5627 +250 1 0.745434 12.1889 11.0782 -25.5268 2.00553 -1.18025 +251 2 18.4134 12.2219 11.1204 10.6569 -0.780029 -7.62666 +252 2 1.00048 12.4147 11.9671 12.4315 1.99225 10.3147 +253 1 5.08453 7.29937 13.4403 2.24753 -3.99956 1.86213 +254 2 5.64891 7.85147 12.8757 -3.98378 2.58677 10.115 +255 2 5.52437 7.26557 14.3066 0.821915 -2.02828 -9.69703 +256 1 1.22699 6.88005 11.8698 42.6355 29.3241 27.8417 +257 2 0.513102 7.24659 11.3736 -15.3023 8.70694 -9.89945 +258 2 1.76616 7.68013 12.1994 -27.3906 -36.7234 -16.475 +259 1 15.5048 9.56381 12.3059 14.0365 -21.5239 -8.17825 +260 2 15.0446 10.3738 12.2505 -11.2614 35.3449 -7.27588 +261 2 15.2981 9.243 13.1696 0.51668 -8.53923 17.0206 +262 1 16.6213 12.8097 5.50479 11.7533 -20.9364 35.7876 +263 2 16.4281 13.7341 5.58129 -4.58024 20.9264 -6.48074 +264 2 16.496 12.5383 4.61195 -7.15835 1.38375 -28.6034 +265 1 6.25272 9.92074 0.051253 25.5558 -5.2213 19.2814 +266 2 5.65499 10.4134 0.617489 -6.63873 2.74854 -0.55683 +267 2 7.09279 9.88715 0.575545 -19.794 1.5448 -11.6918 +268 1 12.3217 6.11544 4.06855 24.0308 27.0278 -26.8963 +269 2 12.2667 6.69224 3.25542 -0.750296 -12.6773 27.7542 +270 2 11.603 5.51542 4.01585 -23.4349 -14.6267 -3.11795 +271 1 0.228308 12.8043 0.188232 11.1572 0.898125 2.61316 +272 2 0.191448 13.5221 0.829575 -7.01271 0.62324 2.49922 +273 2 18.423 13.1312 18.0517 -4.48315 2.42872 -7.20237 +274 1 3.7281 18.597 8.57641 -7.3642 13.4464 17.6561 +275 2 3.55952 18.0214 7.8301 -5.82536 1.28732 -6.71467 +276 2 2.87154 0.379366 8.79158 11.2944 -8.20129 -4.53508 +277 1 7.45075 17.3023 4.47746 -12.4687 -31.8552 -5.62811 +278 2 7.62794 18.1881 4.68695 9.53175 40.2972 16.7849 +279 2 7.50734 17.3052 3.52795 -1.99738 -6.99443 -12.8094 +280 1 9.24058 17.0897 12.2501 -24.9009 9.53262 -6.54721 +281 2 9.25026 16.4035 11.594 -4.50925 -12.7792 -11.7902 +282 2 10.1098 17.0766 12.5981 28.7243 3.47903 16.8433 +283 1 13.2876 12.9366 7.99409 13.1339 47.0026 -12.7195 +284 2 13.3658 12.2269 8.61754 6.78146 -9.97429 11.7811 +285 2 13.946 13.6564 8.215 -16.5737 -23.9385 -2.8436 +286 1 14.9278 2.97205 15.3542 -22.0243 3.95222 27.314 +287 2 14.2978 2.24466 15.255 3.92553 0.418625 -2.59085 +288 2 15.495 2.9795 14.6023 14.212 -3.72656 -21.152 +289 1 9.88733 15.5502 16.9939 -6.96656 2.06857 9.21519 +290 2 10.3024 14.7219 16.7214 3.24805 0.519307 1.1538 +291 2 9.47388 15.4159 17.8681 4.17307 -0.448199 -10.2742 +292 1 11.3272 8.33778 16.5655 -12.1447 -4.13113 3.07889 +293 2 10.5941 7.97459 16.029 11.4521 -0.447246 11.036 +294 2 11.3675 7.80686 17.3849 -1.98947 6.30133 -12.9317 +295 1 3.91087 18.2078 16.7523 8.10648 -24.8729 2.7978 +296 2 4.29329 17.4751 17.2712 -2.30537 5.45923 -13.1249 +297 2 3.83261 0.235403 17.405 -4.96911 23.3333 9.68201 +298 1 2.20524 4.16671 8.93127 -30.922 4.24465 -33.9389 +299 2 3.10409 4.18899 8.66341 29.7515 -2.18627 -0.590115 +300 2 2.16419 4.10976 9.8632 4.73941 -5.36165 36.7803 +301 1 9.8752 10.3748 9.71669 16.1383 -34.8575 15.3318 +302 2 9.43878 11.1114 9.34267 -12.9257 32.2344 -10.6144 +303 2 10.0704 10.5459 10.6459 0.567735 2.49547 1.17829 +304 1 9.70603 0.859612 10.8594 11.2219 3.05072 8.41213 +305 2 9.26848 0.0594607 11.2011 -2.07101 7.3453 -10.3505 +306 2 9.18365 1.30902 10.1791 -6.8322 -10.1071 2.86508 +307 1 9.20299 15.1273 10.2305 31.122 11.5717 5.63223 +308 2 8.76871 15.6899 9.60445 -9.85228 15.7354 -8.32779 +309 2 8.63472 14.3875 10.3233 -23.0991 -20.0884 3.25194 +310 1 0.96837 9.47951 10.2963 -70.5876 8.50765 14.6853 +311 2 0.835229 10.4182 10.5095 11.9906 -6.34251 -2.52384 +312 2 1.84768 9.33537 10.0919 56.817 -0.102153 -14.2985 +313 1 16.9556 4.85371 8.1764 15.2186 15.5475 -39.5257 +314 2 16.4324 5.61135 8.41217 -10.5813 9.18021 7.17639 +315 2 16.8473 4.22258 8.84986 -2.43363 -23.5078 29.961 +316 1 14.6968 14.7113 0.249291 21.1749 6.84176 -19.9636 +317 2 15.2416 15.0749 0.948116 1.7369 4.80193 6.96981 +318 2 13.9408 14.343 0.670519 -22.6431 -9.26918 11.3127 +319 1 3.62773 11.0513 9.55661 13.6415 -11.4582 11.5887 +320 2 3.64622 11.3868 10.4653 -1.2087 2.23818 -2.33891 +321 2 3.18854 11.7052 9.01978 -9.00441 8.94912 -6.83793 +322 1 11.1486 10.7845 1.39435 -11.9859 -27.9615 14.113 +323 2 11.4982 11.6036 1.1014 8.88176 28.2378 -14.4203 +324 2 10.2242 10.7355 1.11217 4.88573 2.00485 1.40976 +325 1 13.1617 7.12114 12.7848 27.9985 9.25187 0.204961 +326 2 14.1485 7.05909 12.8492 -22.0105 -1.86773 -1.16605 +327 2 12.8387 6.22307 12.8528 -4.13181 -6.51108 -0.646654 +328 1 9.62686 1.89618 0.979059 -11.1933 -2.25437 -17.4068 +329 2 8.86583 1.44793 0.536192 15.085 16.0595 8.12302 +330 2 10.1008 2.43338 0.313674 -4.24921 -13.4265 6.88026 +331 1 10.6169 13.5248 4.60784 -18.2432 -3.19473 -12.9411 +332 2 11.3551 12.9251 4.5569 15.1862 -3.85234 3.34493 +333 2 10.6581 13.9134 5.47279 3.49634 8.81883 14.723 +334 1 14.3649 1.74425 10.9305 5.54735 -12.1033 0.31392 +335 2 15.2006 1.47853 10.5325 -1.1471 -9.04293 -1.43649 +336 2 14.4646 2.6903 10.9924 -3.65076 12.6994 -0.169483 +337 1 14.6084 12.2765 11.688 7.48969 -0.0414248 52.7612 +338 2 15.3889 12.4412 11.1797 12.3837 0.874018 -20.9659 +339 2 13.8613 12.0797 11.1652 -22.2598 -6.69151 -32.5036 +340 1 8.22131 5.06515 9.81151 31.4859 -23.4564 -24.7693 +341 2 7.50576 5.35441 10.3398 -29.672 2.17434 15.6894 +342 2 8.09879 4.11038 9.58602 -2.47918 22.6636 6.16193 +343 1 1.53723 16.856 18.3772 -4.91865 -38.0309 19.5229 +344 2 1.81973 17.2424 17.568 8.52952 11.4507 -22.0862 +345 2 1.68062 15.8825 18.2332 -2.55663 27.9439 5.8223 +346 1 1.48989 17.248 15.3251 -39.2991 7.69546 7.77355 +347 2 1.63979 18.1273 15.7491 -10.9611 -20.0854 -9.27397 +348 2 0.505086 16.9983 15.3475 43.8724 16.6347 0.193712 +349 1 3.67894 5.68848 6.10927 6.21387 -9.44646 -9.55971 +350 2 3.15123 6.21186 6.69497 -13.0277 9.84767 14.8728 +351 2 4.18038 6.32117 5.58457 4.58642 -2.3545 -2.10993 +352 1 12.397 9.46521 14.1943 -11.4291 42.6821 2.6577 +353 2 12.6884 8.68898 13.7764 17.0449 -39.3969 -17.6043 +354 2 12.207 9.20402 15.087 -1.24705 -6.16332 16.3323 +355 1 4.0418 15.2774 6.91931 -38.8927 -2.71008 6.44315 +356 2 3.58633 16.0735 6.61178 -2.62598 -4.70343 -0.502904 +357 2 4.94439 15.4914 6.84844 41.7142 6.1892 -4.79175 +358 1 0.605801 8.58372 14.9539 0.254512 0.326548 7.88367 +359 2 0.527439 9.52499 15.1145 -2.4036 7.40824 2.35469 +360 2 1.30759 8.52231 14.3126 8.3049 -1.83762 -9.50966 +361 1 12.9717 8.29262 10.2927 -22.7594 16.3387 10.1639 +362 2 13.6731 7.84025 9.84078 14.5836 -10.6745 -2.92467 +363 2 13.0109 8.02582 11.2281 0.923047 -2.44701 -11.6389 +364 1 15.3232 7.71175 3.53457 4.84131 -0.438878 0.085747 +365 2 14.6048 7.2242 3.18847 -27.3478 1.70601 -26.568 +366 2 15.5504 7.10949 4.22607 20.3905 5.82918 25.2924 +367 1 17.3123 6.68101 0.0543458 25.2448 -11.5383 1.06581 +368 2 16.8643 5.84811 0.208139 -4.52976 -2.78536 3.6701 +369 2 16.6324 7.27442 18.4294 -24.004 18.1506 -8.07094 +370 1 8.88314 6.92259 7.79709 31.0126 27.4325 -12.7619 +371 2 9.82162 7.25311 7.83141 -27.6614 -7.83044 -3.12143 +372 2 8.85418 6.18364 8.38751 -5.1761 -15.9168 16.933 +373 1 12.3742 0.616612 1.23426 0.620177 6.71182 8.7173 +374 2 13.3152 0.448787 1.38768 -5.31542 -0.309906 -0.296651 +375 2 12.0908 0.227811 0.410291 5.35555 -3.35826 -6.33914 +376 1 5.63073 15.1419 14.5354 -14.6404 -24.282 5.65856 +377 2 4.69276 15.2374 14.754 2.80482 -4.42056 0.607876 +378 2 5.89918 16.0006 14.2671 15.2941 25.5531 -11.1631 +379 1 3.85325 6.46699 1.73385 7.01958 -17.0097 2.38606 +380 2 3.51461 7.31896 1.46783 -8.17546 12.9796 -1.79528 +381 2 4.05434 6.54403 2.67764 -3.63249 4.46552 -6.11981 +382 1 3.88854 11.6061 12.3354 -12.5844 1.40703 6.82309 +383 2 4.76337 11.9285 12.5525 8.64878 0.03141 -1.44708 +384 2 3.2838 12.173 12.8501 6.64476 -9.03704 -9.92286 +385 1 5.37483 3.86954 15.8708 7.06931 -74.8011 -5.77053 +386 2 6.14587 3.26348 15.6611 -29.2279 19.2574 6.80998 +387 2 5.70286 4.72315 15.8147 21.5682 55.4234 -2.96121 +388 1 14.3763 10.2794 4.46201 -32.4101 28.4329 49.0365 +389 2 14.443 9.83621 5.32683 0.971611 4.81404 -7.53945 +390 2 14.839 9.74155 3.87936 25.2894 -34.3452 -37.3821 +391 1 7.80918 17.3929 9.15872 22.1479 -28.1908 5.37522 +392 2 6.96403 17.5587 9.551 -17.6194 9.20761 3.63927 +393 2 7.9906 17.9725 8.42371 -6.45863 11.4679 -7.92664 +394 1 4.50911 14.4925 3.93603 -3.72296 -18.8397 -53.7951 +395 2 4.39275 15.3834 4.18687 0.185157 34.2159 14.5975 +396 2 4.6886 13.9787 4.68865 6.61933 -20.0316 37.8242 +397 1 14.2759 7.39669 15.8018 -25.3443 -8.35453 -18.4147 +398 2 15.2098 7.32722 15.7472 31.3188 -3.09541 -3.64929 +399 2 14.1076 7.77613 16.6483 -2.08075 9.82337 20.7866 +400 1 2.98131 18.2876 1.92072 -8.89863 -34.7534 -28.0783 +401 2 2.43865 17.6277 1.38436 23.5626 24.7731 19.3405 +402 2 2.37413 0.302092 2.22775 -14.7638 14.2119 8.82016 +403 1 7.98427 1.62335 4.57287 -40.8947 -0.445207 11.16 +404 2 7.39585 2.15768 4.00383 13.1095 -6.60943 2.01257 +405 2 8.85324 1.63658 4.22836 26.1363 6.2526 -15.7033 +406 1 2.50726 14.1431 17.6951 16.6159 21.4268 -10.1577 +407 2 1.94925 13.5738 18.1946 -18.2656 -19.6261 9.9334 +408 2 3.40865 13.8863 17.9244 2.82527 -4.33175 1.96247 +409 1 0.811695 1.74837 13.8925 -21.7292 3.59652 4.70406 +410 2 0.795118 1.42008 14.8166 -3.87613 7.88135 -16.9479 +411 2 18.5211 1.96459 13.6307 25.6616 -9.0685 11.0917 +412 1 4.4852 18.6484 13.9168 -33.7534 10.3053 3.09674 +413 2 5.3921 18.406 13.9761 25.2496 -8.78408 2.09715 +414 2 4.08373 18.5038 14.7912 8.14506 -1.30426 -6.00867 +415 1 7.12802 0.652367 18.3595 35.0739 -19.2419 -26.0317 +416 2 7.40845 0.19154 17.5185 -9.63956 16.0629 26.4358 +417 2 6.18456 0.683953 18.3433 -21.3742 6.93569 3.25827 +418 1 16.0657 18.4123 14.0301 53.2891 7.60066 12.7833 +419 2 15.2177 18.2242 13.7261 -48.7282 -11.4797 -7.69178 +420 2 16.0808 18.482 14.9966 -9.66087 4.27341 -2.7923 +421 1 10.0672 4.54369 16.2573 46.2132 32.473 -7.3661 +422 2 10.9795 4.93172 16.0704 -30.9355 -10.7562 9.7222 +423 2 10.2805 3.63455 16.4071 -7.05314 -22.7581 -0.39686 +424 1 15.904 17.802 4.45553 44.7656 -19.4466 -14.3322 +425 2 16.4088 -0.0282793 4.41597 5.24747 5.32524 1.83839 +426 2 15.0633 18.045 4.74212 -51.1512 14.4852 15.4733 +427 1 6.99737 17.3998 13.7879 -47.9218 -2.31875 -13.0268 +428 2 7.40243 17.6398 14.5891 19.7576 8.98543 35.5766 +429 2 7.70074 17.2583 13.1843 23.2619 -4.97282 -20.0499 +430 1 13.2941 6.48376 6.64986 8.60711 15.0683 16.7306 +431 2 13.9993 7.1541 6.49159 -11.9149 -19.7057 -4.80273 +432 2 12.8211 6.29295 5.83939 3.46216 6.87198 -11.4398 +433 1 7.76205 2.3443 9.26472 15.7579 10.991 45.3998 +434 2 7.20759 2.25447 10.0765 8.01487 -1.94761 -18.5756 +435 2 7.26048 2.06297 8.52639 -23.6607 -10.4133 -22.8687 +436 1 15.1706 14.8583 13.6757 15.7984 -16.1031 1.44613 +437 2 15.0167 15.231 14.5413 -6.09806 3.71972 9.46304 +438 2 14.6225 15.2955 13.0407 -11.5903 11.1836 -9.13521 +439 1 9.36431 8.31687 3.74781 -9.55399 11.9025 -3.42765 +440 2 10.1518 8.60925 4.20014 9.2003 9.72282 -0.0746101 +441 2 9.3553 7.37835 3.87681 -0.285781 -17.995 1.20514 +442 1 17.7597 13.5616 16.4405 -12.156 -24.6438 9.82021 +443 2 16.8551 13.2283 16.3395 1.48334 1.58847 4.06975 +444 2 17.7289 14.3961 16.0037 5.37456 23.0458 -12.1714 +445 1 4.95841 10.6088 2.75519 -22.9294 18.7883 -14.1686 +446 2 5.66909 10.277 3.27928 16.3083 -8.75526 16.0734 +447 2 4.6114 11.3873 3.23357 6.81328 -15.8641 -4.024 +448 1 3.73362 8.35206 10.1813 3.02598 13.3252 -21.6654 +449 2 3.8939 9.27056 9.86724 -4.6548 -13.2191 9.23973 +450 2 3.49789 8.39898 11.1021 -0.178845 4.23779 13.7606 +451 1 16.0042 7.01418 6.13738 -12.6879 19.8807 -2.17242 +452 2 16.808 7.4479 6.40937 10.6213 6.47779 2.98579 +453 2 16.2019 6.09716 6.06821 5.44302 -25.895 -2.3467 +454 1 15.1221 7.07483 9.10103 -4.15707 -25.1338 32.4641 +455 2 15.7464 7.4872 9.69859 9.03801 3.43378 3.13104 +456 2 15.1481 7.58948 8.33098 1.37226 23.8896 -40.0507 +457 1 6.35284 13.0135 12.8052 -0.193314 -18.9728 -17.7547 +458 2 7.21044 12.6571 13.0708 -4.00291 0.344811 4.20755 +459 2 6.11805 13.741 13.3614 0.492624 18.505 17.8288 +460 1 12.1195 4.49733 13.0969 -26.0004 -21.5883 -29.3264 +461 2 12.1632 4.68913 14.0325 -4.53328 -3.39715 11.6105 +462 2 11.3073 3.93318 12.8667 31.5163 26.387 18.3053 +463 1 11.3554 8.17046 7.8728 -3.27026 2.45633 -4.65198 +464 2 12.0683 7.62612 7.54639 6.23155 -9.6048 -12.5756 +465 2 11.5676 8.24955 8.79484 1.17104 5.44951 18.1694 +466 1 17.1791 10.8374 7.47157 -22.685 17.097 10.0101 +467 2 17.8401 10.2117 7.26521 25.6893 -28.4186 -0.815308 +468 2 17.2004 11.4333 6.72646 -9.08817 8.64759 -4.95169 +469 1 5.26928 18.1244 11.0251 26.2987 0.0330793 2.18763 +470 2 4.69547 17.8637 11.7317 -9.61751 -4.26247 14.7568 +471 2 4.70076 18.4264 10.3375 -16.9 2.57743 -21.8459 +472 1 7.59635 17.5306 1.81531 -10.9531 4.1869 -25.2725 +473 2 7.77056 16.6988 1.31883 2.24077 21.8764 10.5056 +474 2 7.30155 18.2046 1.15131 11.3055 -17.5184 13.1347 +475 1 1.92843 12.8944 13.5862 -6.59595 -16.5477 -16.8116 +476 2 1.43666 12.2821 14.1316 -5.58333 -5.88714 5.06202 +477 2 2.04362 13.6601 14.1181 9.10211 24.5058 14.6097 +478 1 9.63922 6.76943 14.8194 -3.94612 -18.0692 3.52162 +479 2 9.76751 5.80583 15.0218 -0.27339 26.7602 -8.06829 +480 2 9.98245 6.98264 13.9392 -2.96138 -9.43899 0.82382 +481 1 15.2804 4.29771 10.7711 -7.29951 -1.41697 -0.334277 +482 2 16.1821 4.02615 11.0218 -9.71269 11.8498 1.69675 +483 2 14.9105 4.9568 11.3864 17.8049 -7.45406 -3.59162 +484 1 11.2365 6.16159 0.180514 3.71779 6.92115 0.875598 +485 2 11.3264 5.36714 18.3195 14.2335 -18.3801 -6.22284 +486 2 10.2946 6.26806 0.197414 -17.1549 12.9032 2.71424 +487 1 0.0669242 11.3685 15.0652 13.212 -6.85086 18.3683 +488 2 18.0421 11.4114 14.3938 -11.7915 7.94746 -16.0964 +489 2 -0.126536 12.1197 15.6445 1.80559 0.362507 -3.06694 +490 1 7.04679 9.22841 7.26069 23.2883 20.8536 -5.26127 +491 2 6.49897 8.58869 7.67863 -15.4435 -25.8158 9.46312 +492 2 7.95399 8.89143 7.34084 -8.97527 1.37154 -2.4384 +493 1 18.3457 15.377 12.3544 -10.4554 -0.385944 -2.00928 +494 2 0.632165 15.4053 12.1583 18.2501 2.20759 0.366712 +495 2 17.9344 15.8751 11.6412 -4.56296 -0.981709 -1.73702 +496 1 16.5292 4.37759 5.24858 18.1125 19.5767 -27.8403 +497 2 16.7661 4.20984 6.14013 0.307987 -10.9951 33.7785 +498 2 17.3779 4.70209 4.86684 -19.0742 -11.8317 -4.1687 +499 1 17.7267 3.12899 10.7335 -24.2941 -12.2101 -5.28174 +500 2 18.5902 3.43151 10.9823 20.7538 0.196381 3.18907 +501 2 17.7917 2.2294 10.3565 4.74658 11.2046 4.02468 +502 1 12.2912 0.000462328 10.1205 5.29277 -42.3116 -12.7781 +503 2 11.463 0.345322 10.3908 -30.9755 9.64408 8.62664 +504 2 12.8898 0.704281 10.2182 28.9402 34.0259 3.93413 +505 1 10.3772 9.78855 12.3993 -21.9688 -12.411 -17.7787 +506 2 11.0129 9.78765 13.1014 16.013 1.76066 13.7043 +507 2 10.1738 8.8461 12.2399 4.72709 11.7982 0.616329 +508 1 0.569471 2.8284 7.02034 6.04311 -30.2491 -2.51113 +509 2 0.820763 3.41522 7.71636 2.48105 19.4463 13.5049 +510 2 0.862153 1.97327 7.38155 -6.15059 8.48947 -7.95665 +511 1 0.371359 15.3036 6.90441 -15.8595 21.8666 50.0789 +512 2 0.449232 14.6844 7.65301 -0.190166 17.9034 -2.10351 +513 2 0.621967 14.7945 6.18679 16.5003 -37.2512 -48.0182 +514 1 17.0414 7.00877 15.2159 -22.6634 4.89001 -1.64325 +515 2 17.7376 7.6544 15.0563 8.01654 -6.9456 2.15019 +516 2 17.4056 6.16817 15.5101 9.28872 0.897926 -1.45041 +517 1 9.06316 12.4266 8.08985 69.8766 6.47542 -0.0200154 +518 2 9.44101 11.8026 7.43298 -17.7999 4.13897 6.91255 +519 2 8.14431 12.4062 8.1331 -54.6706 -8.19385 -9.80298 +520 1 1.26891 1.85581 2.9921 11.7044 -8.67905 12.4997 +521 2 0.561231 2.0509 2.38915 -6.84046 11.4219 -12.1453 +522 2 1.65109 2.68456 3.32008 -5.2596 -5.54909 -2.36563 +523 1 4.11753 15.1048 9.79523 4.78264 -4.87511 12.6416 +524 2 3.99332 15.4569 8.91057 5.07926 -2.88804 -4.85995 +525 2 5.03278 14.7822 9.88586 -9.66079 5.58119 -5.37355 +526 1 7.25278 2.18203 14.6254 -0.555581 -14.0599 -5.06396 +527 2 7.1005 1.71681 13.7878 -2.90711 2.6098 7.34806 +528 2 7.71992 2.97108 14.3713 4.55177 12.8631 -2.10328 +529 1 18.557 14.6494 2.1729 -24.7771 22.3853 -4.36836 +530 2 0.778963 15.0461 2.09778 12.8139 1.02797 3.11036 +531 2 17.9275 15.4159 2.12338 10.4684 -24.8222 2.25012 +532 1 9.97282 2.76121 12.909 0.960373 12.9666 17.7509 +533 2 9.84581 2.0662 12.2717 -5.76657 -8.74665 -14.3806 +534 2 9.17654 3.31629 12.9308 6.08178 -3.78367 -5.74316 +535 1 2.89833 8.91803 13.044 14.9503 3.68581 0.826535 +536 2 3.29774 9.80788 12.9186 -7.17545 -13.4779 0.185991 +537 2 3.62224 8.34145 13.3619 -7.75262 8.46695 -4.72395 +538 1 3.21711 8.45664 3.69888 -1.45646 11.2765 -73.7917 +539 2 3.66926 9.20612 3.219 -10.9411 -20.3742 19.6072 +540 2 3.34915 8.55803 4.60102 11.7629 13.1896 57.1484 +541 1 5.60205 7.18882 8.56127 11.7766 6.17403 -13.6051 +542 2 5.73377 6.23122 8.60856 -5.21401 3.91262 5.39773 +543 2 5.15686 7.50265 9.34977 -6.87961 -7.75657 6.1504 +544 1 14.8989 1.38427 1.96946 -15.0866 25.6457 3.84218 +545 2 14.4906 2.19786 2.32837 7.96598 -16.9425 9.74227 +546 2 14.9786 1.62425 1.05302 13.5137 -6.97514 -15.0219 +547 1 8.3539 15.1902 0.828571 -0.607384 -15.7884 -3.69873 +548 2 9.11456 14.9295 1.35098 9.06641 9.90213 6.9538 +549 2 7.64957 14.6447 1.20074 -5.27592 0.575252 -4.39528 +550 1 15.5904 1.35118 7.21966 19.131 18.1941 14.0102 +551 2 15.0458 0.788774 6.70847 -19.486 -21.9805 -16.5491 +552 2 15.0172 2.08736 7.44992 -1.58717 6.06663 4.11757 +553 1 4.99095 13.0428 18.5017 -11.814 -5.03203 -22.7016 +554 2 5.38558 13.1981 0.699871 9.67176 2.40993 22.9792 +555 2 5.69857 13.2122 17.8695 -3.662 3.61759 -0.881885 +556 1 15.3616 8.52427 18.1264 -8.5134 -8.81723 23.808 +557 2 15.7284 8.98559 17.3934 10.1937 15.818 -24.0842 +558 2 15.2728 9.20414 0.16849 -1.83009 -5.75583 -0.912989 +559 1 12.0932 3.04939 18.3516 -14.5656 24.4873 8.42937 +560 2 12.4759 2.51827 0.417994 -2.38649 -9.33387 -9.98316 +561 2 12.2916 2.69447 17.4847 9.72648 -15.0074 2.48816 +562 1 13.2068 12.6815 5.17314 -7.19784 6.47098 -0.665029 +563 2 13.7108 11.8878 4.96601 4.53767 0.295949 3.70661 +564 2 13.3847 12.9363 6.09127 2.00425 -11.4311 -4.02895 +565 1 6.06883 7.14745 0.0914664 -7.81354 22.5487 2.98517 +566 2 5.88319 8.11419 0.19427 8.4279 -22.2037 -4.79949 +567 2 5.22519 6.72532 0.292473 3.10856 -0.243494 3.48057 +568 1 17.7194 15.9325 14.9871 -5.54638 -4.40987 -28.7902 +569 2 16.9069 16.4169 14.9498 -12.3977 10.2544 17.1316 +570 2 17.7594 15.7087 14.0393 19.0068 -3.79668 12.8095 +571 1 13.1727 0.977833 16.5926 -11.6444 6.00991 -1.45652 +572 2 14.0026 0.708875 16.9779 14.0624 -0.886732 -0.671765 +573 2 12.7076 0.152182 16.4397 -1.15444 -5.20647 -2.10321 +574 1 11.0384 14.6069 7.3103 -17.4066 -34.6271 2.52502 +575 2 10.2783 14.0261 7.58336 17.6612 20.778 -3.294 +576 2 11.8174 14.0391 7.44317 -4.14385 7.222 1.39489 +577 1 17.5379 8.55913 2.08836 4.35413 -11.6997 -13.5411 +578 2 16.664 8.39738 2.48219 7.20941 -2.48593 -6.20174 +579 2 17.6519 7.91106 1.34391 -7.20398 14.5397 25.454 +580 1 12.3635 7.91649 1.96817 14.6342 -23.934 -0.413214 +581 2 11.8532 8.69875 2.12901 -10.659 13.0689 -1.52352 +582 2 11.9409 7.3888 1.27378 0.548374 7.65925 3.61612 +583 1 11.9419 14.6308 10.3966 13.4402 32.5881 48.4479 +584 2 12.2905 14.0069 9.8182 12.9115 -34.2012 -37.3181 +585 2 11.0351 14.785 10.1903 -23.9611 0.860738 -9.13817 +586 1 6.84298 6.98317 15.5594 -28.1276 -29.1686 -18.0428 +587 2 7.705 6.91496 15.176 20.6419 5.27277 -3.3528 +588 2 6.85291 7.68491 16.1747 6.25697 23.8787 22.837 +589 1 8.01998 4.63032 13.4448 -35.0292 -26.7707 -36.5428 +590 2 7.42844 4.80515 12.6548 14.5268 -5.56395 32.2217 +591 2 8.43798 5.44118 13.6312 16.8653 30.885 3.99265 +592 1 13.3984 12.173 14.3104 -3.57217 10.7678 8.64565 +593 2 13.233 11.2355 14.1881 -1.19303 -4.98427 -3.70246 +594 2 13.8945 12.4998 13.5522 0.86121 -3.67781 -4.0367 +595 1 14.7231 9.47939 7.26845 -4.38272 9.59825 17.375 +596 2 15.5232 10.0108 7.49545 -18.3981 -9.5314 -3.88615 +597 2 14.0057 9.68134 7.91225 20.1628 1.06432 -13.939 +598 1 12.7179 16.9622 3.14627 23.4566 -37.2939 -10.6207 +599 2 12.9355 17.1415 4.04114 9.03221 7.6908 26.6047 +600 2 12.0213 17.5358 2.94483 -34.3001 33.1559 -14.5415 +601 1 1.10947 7.12267 17.419 -6.10821 -8.12856 16.9857 +602 2 0.178422 7.136 17.6887 4.23762 -2.5375 0.360706 +603 2 1.14096 7.54201 16.5672 -1.29203 8.00191 -14.7545 +604 1 12.8573 5.07319 15.6916 -26.4132 -0.426227 -0.347566 +605 2 13.5067 4.42508 15.4662 18.5417 -18.6841 0.103563 +606 2 13.3354 5.89586 15.6754 6.08426 15.3432 1.29959 +607 1 2.44451 3.37888 5.09109 -12.3042 -30.7639 -30.2825 +608 2 1.89914 3.20439 5.84354 -15.8924 -6.60657 16.2411 +609 2 2.9157 4.14854 5.30475 25.2943 38.046 11.4255 +610 1 8.30318 11.1757 13.537 -17.7368 31.3122 -83.5918 +611 2 8.23756 10.9827 14.4193 9.23305 -26.2584 72.471 +612 2 8.98641 10.7011 13.0548 11.9243 -7.18625 13.6047 +613 1 12.9121 1.44799 13.2982 3.17544 -30.959 19.595 +614 2 13.5829 1.31511 12.6431 13.7174 -5.57278 -14.8203 +615 2 12.5671 2.27513 13.0597 -18.9903 37.7092 -4.23536 +616 1 6.45025 13.6395 2.14169 21.7214 -12.6454 -10.4453 +617 2 5.88722 14.0323 2.78408 -20.3944 14.637 16.9787 +618 2 7.03563 13.0797 2.67163 0.317992 1.20831 -5.89746 +619 1 15.9341 6.54969 12.734 7.51439 18.2634 -8.82177 +620 2 16.366 7.12442 12.0552 -8.93517 -14.9663 18.1444 +621 2 16.3202 6.79095 13.5987 -1.79943 -6.04596 -11.4359 +622 1 16.8134 0.715269 9.59469 1.51011 24.5111 -1.75686 +623 2 16.9773 18.4324 9.6759 -2.99022 -25.9416 6.21625 +624 2 16.4855 0.841275 8.69831 -5.26956 1.43879 -3.58435 +625 1 6.14183 11.6821 8.34851 2.12045 33.7206 2.80541 +626 2 5.25373 11.5769 8.68031 -11.2997 -2.21294 6.8592 +627 2 6.41363 10.8186 8.10997 12.8023 -29.2169 -10.6172 +628 1 2.82878 8.69633 0.366162 65.7357 7.98524 25.914 +629 2 2.25196 8.1872 18.4995 -43.1364 -19.0897 -25.1642 +630 2 2.39827 9.3921 0.850531 -20.8372 5.7472 0.329713 +631 1 10.1125 10.4546 6.55694 -3.88563 -4.31924 12.8938 +632 2 10.5628 9.81084 7.11921 -1.26662 -0.776779 -0.718706 +633 2 10.7076 10.6109 5.83303 6.58413 -0.38446 -16.1853 +634 1 6.75197 15.7318 6.59922 10.1749 2.21511 -7.15796 +635 2 7.21229 16.0038 7.38721 0.121014 2.00215 12.9298 +636 2 7.17446 16.2736 5.9175 -9.12202 -3.23328 -2.5626 +637 1 6.44006 13.071 5.66115 9.01876 9.03356 -0.68679 +638 2 6.7952 13.9213 5.9766 -6.67057 -7.15315 -1.80184 +639 2 6.02558 12.6573 6.41982 -1.29087 -3.79345 3.79648 +640 1 16.7894 12.5351 9.7661 -6.01106 14.3853 23.3751 +641 2 16.9466 11.9627 9.02496 7.22561 -5.83165 -16.8213 +642 2 17.1452 13.4178 9.59292 -0.312151 -9.66884 -5.48162 +643 1 6.11103 2.94777 2.80745 -0.0522908 21.1759 -16.381 +644 2 6.20729 3.87808 2.49328 4.01665 -19.1858 15.5438 +645 2 5.82625 2.47942 2.01203 -2.73031 -5.31149 4.59086 +646 1 10.8562 3.22295 3.2592 5.83487 -6.01133 1.10343 +647 2 10.3184 3.99141 3.45824 -8.06424 0.347936 -1.44444 +648 2 10.5285 2.8344 2.43843 -2.26863 2.18612 2.83427 +ITEM: TIMESTEP +50 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.76267 6.9614 17.9655 18.039 1.32171 0.971735 +2 2 7.88851 7.04905 18.3237 -17.7355 -1.2272 4.07533 +3 2 8.77103 6.18416 17.4071 -1.73171 -4.43635 -4.46665 +4 1 18.7148 8.30367 6.79977 -11.0979 19.7573 -45.8218 +5 2 0.340011 8.13606 5.84126 -7.49685 -0.624375 38.3142 +6 2 0.514278 7.70743 7.38333 14.5888 -19.2797 9.57425 +7 1 8.47639 18.6969 6.83361 -13.2294 -1.25401 8.78355 +8 2 9.37315 0.218195 6.58559 19.0885 2.32763 -3.91705 +9 2 7.98208 0.748711 6.39478 -2.33131 3.58411 -1.86541 +10 1 6.52812 1.78346 11.693 -34.4751 -1.18092 9.20038 +11 2 5.67737 2.21709 12.0036 34.6116 -15.9045 -8.19534 +12 2 6.27488 0.856486 11.479 2.31906 19.7771 3.09659 +13 1 7.04596 5.66579 2.40189 46.2065 -42.3734 -14.42 +14 2 6.39782 6.00892 2.95716 -37.9245 28.3982 32.5204 +15 2 6.93615 6.04049 1.54428 -8.317 15.9019 -18.5798 +16 1 16.2302 10.236 16.0835 20.9593 -16.5275 2.4245 +17 2 17.1756 10.4542 16.2372 -23.2351 0.455296 -7.02457 +18 2 15.6872 10.9657 16.3738 0.757377 12.3052 3.78761 +19 1 10.6519 14.9414 2.32488 9.23959 14.6152 1.78567 +20 2 10.6414 14.4628 3.16471 0.797937 2.29677 -5.70575 +21 2 11.1604 15.7599 2.50148 -7.89724 -14.8548 -1.26363 +22 1 17.1653 8.24769 10.628 -7.00673 -3.15457 9.83212 +23 2 16.8168 8.85992 11.2947 -1.87186 0.196375 -6.64951 +24 2 17.9222 8.68524 10.2369 7.99899 3.60318 -1.68622 +25 1 14.7266 15.9157 16.4191 -13.8739 15.1565 -8.48964 +26 2 13.7936 16.2384 16.3951 24.1732 -8.40377 0.758561 +27 2 14.8582 15.5746 17.3097 -4.06225 -5.68183 -0.795501 +28 1 12.1165 13.3951 0.497647 12.4663 -12.7582 1.83308 +29 2 11.9617 13.3954 18.1814 -7.51799 5.11576 7.21512 +30 2 11.4424 13.8646 1.00511 -0.599491 5.86198 -7.65109 +31 1 9.3022 5.46358 3.98483 37.3 9.28522 -25.3544 +32 2 8.76176 5.25183 4.70521 -26.4917 -13.7331 37.3539 +33 2 8.69012 5.59126 3.27137 -14.2398 -0.31671 -15.324 +34 1 1.75646 4.13824 11.6126 7.13571 -34.631 6.10286 +35 2 1.57168 5.01735 11.8974 -3.49495 27.0073 7.26754 +36 2 2.15491 3.66767 12.3745 -6.50879 7.63382 -13.9832 +37 1 2.03017 6.80422 8.30837 9.29028 16.8447 12.8872 +38 2 2.52076 7.32809 8.97976 -10.1379 -7.93343 -11.4013 +39 2 1.79129 5.98703 8.76166 3.66627 -1.3648 -7.3534 +40 1 5.38278 4.45139 7.96045 1.48715 2.78745 -0.615366 +41 2 5.47525 3.53905 7.69237 2.73507 -15.0654 6.73754 +42 2 4.91072 4.84535 7.233 -11.388 9.54401 -10.9371 +43 1 3.30811 2.94776 17.4802 13.944 -42.282 -21.1312 +44 2 3.9986 3.21817 16.868 2.68053 3.29728 -0.298822 +45 2 3.01647 3.72731 17.8911 -19.397 34.8415 21.3069 +46 1 7.43048 5.35311 6.10326 -4.25319 -13.0158 -27.7806 +47 2 8.09022 5.89476 6.48364 23.034 26.3027 15.5228 +48 2 6.99872 4.97144 6.84559 -15.3695 -14.0963 19.964 +49 1 9.79676 7.01231 12.0156 -14.7328 3.59156 -15.7655 +50 2 10.3705 6.43202 11.4882 -9.23999 6.31012 5.56299 +51 2 9.04301 7.2927 11.4294 23.3546 -9.34629 13.9639 +52 1 14.0089 3.6286 8.06931 13.5755 5.11429 34.4728 +53 2 14.0074 4.36435 7.46412 -2.30693 7.62473 -7.33974 +54 2 14.3705 4.00595 8.91563 -10.4749 -13.1534 -24.8623 +55 1 4.55657 17.1558 3.95973 -9.28017 -24.3455 25.7085 +56 2 5.47914 17.3407 4.055 21.0307 11.7367 -4.03215 +57 2 4.1348 17.6911 3.31263 -3.95253 16.2794 -25.0192 +58 1 16.4751 16.614 10.2504 -32.3258 -7.85569 21.4695 +59 2 15.6275 16.6356 10.7813 29.977 2.99208 -16.9651 +60 2 16.2718 15.9944 9.53771 -1.01186 4.78751 -1.5712 +61 1 1.9619 4.81867 0.319959 -10.9755 -9.70287 -18.0846 +62 2 2.61752 5.08919 0.942567 15.1261 9.15008 18.4356 +63 2 1.74644 5.61951 -0.161427 -5.07436 5.04444 -4.19633 +64 1 11.5961 13.2841 16.3358 -4.45358 14.5896 10.2849 +65 2 11.0454 12.5131 16.3954 -10.7816 -16.1685 4.94665 +66 2 12.1536 13.1064 15.5876 11.3576 1.56581 -12.6168 +67 1 10.1325 11.0245 16.8746 -17.0839 37.329 0.881875 +68 2 10.5383 10.188 16.8005 14.1256 -36.2582 -1.95739 +69 2 9.19072 10.9065 16.7053 -0.138929 -3.60954 1.11764 +70 1 11.7656 17.449 13.475 -8.50487 25.248 2.18402 +71 2 12.3632 17.1066 12.8073 4.24528 -3.45864 -2.0733 +72 2 11.8231 18.4283 13.4081 4.57434 -16.4673 0.201387 +73 1 6.41878 9.35136 12.2283 -7.50229 14.2202 21.4939 +74 2 6.8057 8.89086 11.4896 12.6266 0.651555 -6.79619 +75 2 7.09031 9.88696 12.7035 -9.91308 -10.3657 -12.0835 +76 1 16.2619 12.8358 2.69678 7.42582 31.4023 -4.83963 +77 2 17.0939 13.3284 2.51069 -14.3032 -16.3414 4.28546 +78 2 15.5824 13.5473 2.68145 7.19887 -17.4175 4.43499 +79 1 0.698809 12.6212 5.89369 35.48 3.16674 13.5988 +80 2 0.938081 12.5288 4.97754 4.92149 -4.10163 -12.4931 +81 2 18.4194 12.7439 5.90006 -39.8609 3.63618 -4.1467 +82 1 5.237 16.4363 18.426 1.65878 -0.316472 9.22308 +83 2 5.81108 15.7548 18.0954 4.21498 -13.4949 -13.2329 +84 2 5.56972 16.5656 0.670239 -4.67124 7.34541 5.05152 +85 1 0.592121 7.69947 4.15467 -58.6061 -26.6762 36.9237 +86 2 18.6393 8.0928 3.5307 -12.7545 6.31849 -14.8448 +87 2 1.4218 7.85573 3.82511 72.6481 19.3185 -25.9209 +88 1 3.11983 8.96532 6.48794 54.6199 12.7003 -22.2767 +89 2 3.76913 8.45297 6.98254 -4.7725 1.8296 2.92636 +90 2 2.27977 8.75705 6.803 -46.0396 -12.4219 19.8369 +91 1 7.29807 10.3702 16.2638 20.6686 -0.114663 -24.6428 +92 2 6.66655 10.506 15.5642 -5.16108 2.7891 -5.34334 +93 2 6.78521 10.2638 17.0451 -10.3715 -1.64006 24.8745 +94 1 11.1174 0.987619 5.00277 -7.18116 3.53088 7.25248 +95 2 11.0089 1.86145 4.60844 7.25629 1.31859 -0.585836 +96 2 10.7387 0.391071 4.35918 -2.65397 -7.99376 -8.61355 +97 1 4.35641 2.82374 13.2083 -1.43301 42.1246 -29.6721 +98 2 4.74578 3.12447 14.0221 1.91906 -0.955597 13.0676 +99 2 4.17771 1.91012 13.264 -5.21231 -41.1093 14.0839 +100 1 8.41102 10.1748 1.81577 -7.29686 12.4487 -22.3398 +101 2 8.22152 10.8552 2.46036 0.4991 6.95458 5.373 +102 2 8.69583 9.43786 2.3232 10.7851 -24.1065 14.6426 +103 1 10.4306 1.70557 15.5491 18.4702 5.47966 -9.86629 +104 2 11.3921 1.67519 15.3716 -14.7227 -5.4908 8.94093 +105 2 10.0695 2.09393 14.7416 -3.28742 -2.92827 -1.64813 +106 1 2.67775 12.9037 7.82287 3.09642 7.69249 12.8714 +107 2 3.27779 13.5956 7.51776 -0.922255 -1.64886 -5.76029 +108 2 2.01429 12.7843 7.13996 -0.0248334 -2.64481 -5.98892 +109 1 3.74038 11.6511 5.07858 19.3958 17.4162 2.05128 +110 2 3.60589 10.7736 5.39333 -4.06789 -18.6575 13.0804 +111 2 3.07486 11.8033 4.42286 -17.2397 4.77378 -8.56343 +112 1 6.72135 14.4316 16.9296 11.8603 14.2358 -0.0778856 +113 2 7.64698 14.6853 17.0511 -5.38436 -3.23295 2.03342 +114 2 6.43726 14.8986 16.1349 -2.65892 -7.20284 -3.09426 +115 1 14.1884 14.544 3.35185 -21.8252 -0.368401 10.0779 +116 2 13.5247 15.1958 3.05461 14.5314 -4.887 4.26149 +117 2 13.7567 14.0734 4.09815 10.0173 4.52685 -16.1607 +118 1 8.41325 18.11 16.0503 -13.4237 14.7481 -2.40694 +119 2 9.01353 17.4146 16.1754 14.4883 -45.0972 12.851 +120 2 9.02228 0.139466 15.7926 3.66197 31.0187 -5.55304 +121 1 4.74026 1.68368 4.91774 -8.81747 -38.2992 48.653 +122 2 3.89365 2.07173 5.09257 -16.8489 9.86366 -0.181142 +123 2 5.05165 2.08173 4.1548 23.8621 30.7653 -48.3713 +124 1 15.012 12.6397 16.4637 21.182 -20.8114 -27.7575 +125 2 14.6363 13.1316 17.1743 -19.1608 12.2632 11.0748 +126 2 14.4002 12.4571 15.7145 4.23163 12.8017 20.733 +127 1 15.7141 18.464 16.8736 -48.8091 1.63943 -48.6642 +128 2 16.4537 18.5656 17.3974 52.451 1.55627 42.8989 +129 2 15.6088 17.527 16.6934 -4.99653 -8.13868 6.26406 +130 1 1.24245 1.19714 16.5568 -3.35795 -9.15112 -9.15157 +131 2 2.06126 1.67967 16.5955 12.2536 9.19 1.95012 +132 2 0.738255 1.56007 17.2754 -9.1343 5.49748 13.2621 +133 1 18.1403 4.48045 15.9024 -8.92064 9.41796 12.6958 +134 2 18.2534 3.91822 15.1507 3.10214 -9.7063 -13.7449 +135 2 0.333051 4.53253 16.3579 6.8431 0.540548 1.72555 +136 1 12.2576 16.9773 16.1451 24.3374 26.4028 -39.8206 +137 2 11.5235 16.7559 16.6626 -39.484 -19.8089 22.2101 +138 2 11.9275 17.1263 15.229 8.36672 -7.61232 16.8746 +139 1 16.0311 2.54163 18.1267 15.2184 -17.5558 18.8253 +140 2 15.6351 3.35325 18.4083 -9.02057 20.5203 4.48377 +141 2 15.9018 2.48695 17.1953 -7.32995 1.76863 -25.4669 +142 1 6.72575 13.8191 10.1968 -9.26978 -14.9128 -14.7006 +143 2 6.45064 13.4802 11.0509 2.35225 3.79258 9.11016 +144 2 6.47529 13.1065 9.58166 7.75573 8.69288 2.20437 +145 1 10.1667 18.3423 2.73278 -21.0918 -24.4685 17.5154 +146 2 10.3808 0.422697 2.17354 8.51297 19.7321 -20.8009 +147 2 9.25877 18.0911 2.47579 12.4496 3.13566 3.08398 +148 1 3.02618 17.7182 6.12046 9.12785 6.17449 -5.85825 +149 2 2.19895 17.4959 5.67953 0.482163 3.05546 -3.6427 +150 2 3.66706 17.9189 5.4073 -11.2068 -9.39986 11.0759 +151 1 12.5962 16.8879 7.98687 8.69067 0.386489 -7.96768 +152 2 11.911 16.2378 7.93697 -12.2796 -18.2514 -9.64148 +153 2 12.3467 17.3792 8.75804 4.49939 18.0195 12.184 +154 1 14.8895 15.2713 8.19847 3.78441 6.77747 -24.1674 +155 2 14.0908 15.8092 8.10802 0.530475 -1.70182 9.59272 +156 2 15.3507 15.4528 7.3473 -4.11878 -7.96121 22.2836 +157 1 17.7044 18.2264 0.345927 53.2191 22.2557 3.1655 +158 2 18.611 17.8064 0.306571 -34.334 1.581 -6.33561 +159 2 17.9464 0.534475 0.465882 -17.8927 -21.106 -0.514669 +160 1 0.816649 10.4426 1.34739 14.8692 48.9775 -23.6448 +161 2 0.0612409 10.0129 1.68761 -29.4632 -23.0248 11.5333 +162 2 0.465717 11.2339 0.843051 15.2672 -28.7963 15.4324 +163 1 1.72991 12.2406 3.39174 -15.9976 -2.88445 -44.3457 +164 2 1.42407 11.5936 2.70825 8.45982 5.87631 22.8389 +165 2 1.72198 13.0652 2.87637 5.68226 -3.3333 12.0496 +166 1 0.611993 17.231 4.90821 -34.3512 10.3394 53.8078 +167 2 18.7649 18.0776 4.93361 14.0145 -8.94618 -14.8948 +168 2 0.320128 16.8659 5.79609 20.9887 -2.41003 -36.5782 +169 1 1.10304 0.897417 9.42158 -11.0752 -12.4205 -5.86027 +170 2 1.33193 0.471936 10.271 -7.8206 6.77035 -10.9921 +171 2 0.260273 0.49253 9.11811 18.1645 10.0729 11.6017 +172 1 16.7431 2.34345 13.2996 -3.12231 -7.25082 27.0749 +173 2 16.9139 2.55723 12.403 6.00909 8.65593 -29.5603 +174 2 16.479 1.41627 13.3001 1.0866 -1.80785 3.13205 +175 1 2.64585 15.864 12.1283 -21.2463 14.7527 -7.08654 +176 2 3.15605 15.3934 12.7599 11.6364 -10.3414 18.5671 +177 2 3.00262 15.6045 11.2815 4.79088 -2.17896 -11.8296 +178 1 16.4298 15.6598 6.07287 -23.7839 -45.9221 18.6798 +179 2 17.316 15.6562 6.39936 21.0579 5.20152 4.08476 +180 2 16.3078 16.3335 5.44341 2.1367 33.4546 -25.3893 +181 1 5.80337 5.0927 11.7988 -16.1764 10.2154 8.68093 +182 2 5.24436 5.75105 12.277 17.1169 -11.9851 -7.24057 +183 2 5.28663 4.27668 11.796 1.81497 4.13117 2.00496 +184 1 15.1635 4.86687 0.779797 10.276 15.6296 -42.8981 +185 2 15.0374 4.47718 1.61189 -4.55383 -15.7546 43.9488 +186 2 14.356 5.34586 0.597493 -2.57536 1.02491 -2.93315 +187 1 16.3458 16.3763 2.04771 3.47576 3.66541 23.8501 +188 2 16.2044 16.7006 2.97252 -3.72753 -7.68524 -25.3267 +189 2 16.7389 17.1226 1.58867 -0.552753 3.82143 -4.99822 +190 1 0.255881 4.83863 3.82235 -11.3764 -61.9515 -5.66134 +191 2 0.347221 5.7447 3.93716 8.7619 60.1171 8.48532 +192 2 0.834328 4.39842 4.45398 2.37129 4.71095 -1.99834 +193 1 2.9563 15.0569 15.1257 1.71124 8.82343 -41.1566 +194 2 2.85861 14.8634 16.033 -5.32392 -14.5435 34.6784 +195 2 2.48389 15.8911 15.0234 3.12674 0.885842 0.387353 +196 1 1.13777 14.6522 9.5263 -30.3315 0.106042 24.0606 +197 2 1.89024 14.3075 9.07024 17.4708 -15.5826 -4.95385 +198 2 0.933623 14.0402 10.2733 8.29602 9.54759 -23.1661 +199 1 13.5292 16.584 11.5416 25.6454 -21.6132 21.0377 +200 2 13.328 17.2834 10.9465 -13.4726 19.9213 -18.5602 +201 2 13.2496 15.765 11.1158 -9.99742 3.11837 -0.28929 +202 1 4.66126 1.44669 0.76776 24.0608 13.759 -10.2694 +203 2 4.19513 2.00271 0.14116 -5.95148 5.85957 -2.67997 +204 2 4.06121 0.755814 1.00952 -11.6339 -11.0076 11.757 +205 1 1.46276 18.5641 11.8468 9.16484 -20.9655 21.4802 +206 2 1.29795 0.448688 12.6433 2.09315 -1.75191 -4.75625 +207 2 1.84947 17.7191 12.1761 -6.39306 18.521 -9.12508 +208 1 11.4915 10.1299 3.99438 -29.0311 -19.3551 44.8744 +209 2 11.2201 10.4871 3.17848 -8.25775 15.5063 -35.6965 +210 2 12.4189 10.233 4.02648 37.0944 1.09916 3.99775 +211 1 8.27499 12.1796 3.66337 18.6814 -7.12196 -36.2468 +212 2 9.0689 12.5922 3.98877 11.875 7.24467 3.22649 +213 2 7.6764 12.2152 4.36849 -32.1167 2.17346 40.1921 +214 1 14.4874 4.01368 3.28039 -17.5005 -0.0616197 -21.9184 +215 2 14.9648 3.93911 4.08552 21.5727 -0.139675 21.9436 +216 2 13.7566 4.60071 3.48465 -5.84393 1.34015 1.64127 +217 1 5.62374 1.66322 7.51635 70.0554 58.4457 -44.6253 +218 2 5.02312 1.16941 7.9611 -67.4835 -53.4064 45.1295 +219 2 5.39821 1.60037 6.57846 0.425083 -1.20148 0.902483 +220 1 17.8844 1.0604 4.85627 -10.0966 -7.93422 8.12116 +221 2 18.57 1.49808 4.37578 15.6561 4.82809 -15.3219 +222 2 17.6975 1.64814 5.58583 -4.12013 1.11537 7.77052 +223 1 6.80576 9.4106 4.49942 14.9318 -4.14838 16.3077 +224 2 6.92469 9.61899 5.44741 -8.81338 -3.93454 -14.2946 +225 2 7.68422 9.10473 4.22333 -4.88591 1.73472 -0.668879 +226 1 2.61188 14.876 1.98504 -6.91902 -4.93882 19.1315 +227 2 3.25848 14.7083 2.68056 -2.68924 0.660774 0.84214 +228 2 3.12462 14.9058 1.19269 5.2127 1.18228 -19.2613 +229 1 17.303 12.9246 13.1525 10.3788 -12.5807 -3.95397 +230 2 16.4389 13.2985 13.3385 -0.36563 10.0164 -0.276732 +231 2 17.9169 13.6449 12.9311 -14.7092 -1.11942 1.9762 +232 1 14.9246 10.553 1.38722 24.8563 30.4026 18.8772 +233 2 15.5245 11.2788 1.76222 -27.4309 -28.2887 -15.3922 +234 2 14.0162 10.8271 1.54897 4.06804 -0.689498 -1.36825 +235 1 5.72717 6.70809 4.58418 -6.56467 23.581 -8.85087 +236 2 6.06385 7.62371 4.66236 -8.01259 -10.4186 -5.73866 +237 2 6.2767 6.1943 5.16785 8.48743 -6.29877 6.22452 +238 1 8.0009 8.33508 10.3687 14.1913 1.83663 -35.3126 +239 2 8.52082 9.13006 10.161 -0.0651459 -5.63876 7.89795 +240 2 7.94932 7.91253 9.48819 -6.75295 -2.00865 18.056 +241 1 13.4409 18.4268 5.72382 16.6357 0.722738 -15.7997 +242 2 12.6296 0.221713 5.47389 -5.04693 11.9449 -2.85301 +243 2 13.1936 17.8965 6.46343 -5.47963 -14.8645 21.1785 +244 1 0.0859293 2.63743 0.236192 -9.12202 -35.143 -2.56963 +245 2 17.9325 2.9505 -0.168165 -24.3821 -4.07692 -4.34214 +246 2 0.590564 3.4143 0.297916 33.333 32.0117 7.87133 +247 1 12.8395 11.0444 9.74231 45.1743 -31.9509 26.4779 +248 2 11.9686 11.0602 9.42407 -43.5447 -1.91263 -10.9888 +249 2 12.9558 10.1388 10.1456 -3.41612 23.6256 -14.6869 +250 1 0.710059 12.1592 11.0756 -10.531 -0.362272 -11.4251 +251 2 18.3753 12.1255 11.106 13.0957 4.94421 7.25875 +252 2 1.07349 12.4339 11.9177 -3.83141 1.58371 11.017 +253 1 5.10203 7.3136 13.4291 15.7719 5.5957 -0.396148 +254 2 5.6162 7.93373 12.8769 -6.75271 -3.40235 8.70115 +255 2 5.62723 7.25347 14.2483 -7.64248 -3.9813 -9.01905 +256 1 1.21129 6.85545 11.8946 29.9494 36.4661 12.0403 +257 2 0.485742 7.25442 11.415 -4.88796 -0.516932 -2.56673 +258 2 1.80546 7.64481 12.127 -26.2797 -36.2571 -7.59378 +259 1 15.5076 9.61367 12.3051 21.7085 -42.1446 -13.9552 +260 2 15.1772 10.4675 12.1584 -16.5272 42.565 -1.064 +261 2 15.3545 9.37182 13.2055 -3.21788 1.51701 18.7315 +262 1 16.6116 12.7513 5.5295 7.16384 -7.58562 22.1279 +263 2 16.3878 13.6701 5.61583 -3.61437 18.1746 3.54477 +264 2 16.4616 12.5615 4.61757 -3.38991 -5.42355 -25.0954 +265 1 6.3014 9.86096 0.0280098 12.3864 1.00447 14.78 +266 2 5.6246 10.4136 0.42972 -1.13337 -0.2267 2.50286 +267 2 7.03571 9.82087 0.686012 -15.2579 5.10695 -14.0237 +268 1 12.3034 6.12839 4.06739 18.1147 15.8957 -28.6536 +269 2 12.3348 6.66771 3.23063 -4.28261 -10.1618 29.3394 +270 2 11.5855 5.52112 3.9529 -14.8183 -8.35162 -1.01689 +271 1 0.289245 12.8118 0.17396 1.00074 4.7721 1.62068 +272 2 0.031574 13.4709 0.828681 0.933398 1.09562 1.96647 +273 2 18.4473 13.0492 18.0252 -3.3255 1.79332 -7.06642 +274 1 3.67377 18.6092 8.59256 -12.2718 12.3972 8.90671 +275 2 3.51633 18.2244 7.72678 0.0355868 -3.61867 -2.60117 +276 2 2.80982 0.36536 8.82196 13.0622 -5.69839 -0.636093 +277 1 7.44701 17.3263 4.47819 -12.2479 -42.1382 8.27198 +278 2 7.47198 18.2285 4.71954 7.46065 34.1282 3.2472 +279 2 7.59543 17.2523 3.54279 -0.328999 6.68987 -14.4609 +280 1 9.24493 17.1077 12.2387 -39.9724 15.9122 -7.56371 +281 2 9.27102 16.3677 11.6468 4.90539 -16.8252 -9.88175 +282 2 10.091 17.2207 12.6154 35.0883 -2.17581 15.9571 +283 1 13.2831 12.983 8.01599 31.7457 23.9761 -1.258 +284 2 13.3856 12.1913 8.53584 -3.88389 -9.78552 5.15809 +285 2 14.1414 13.4672 8.16531 -29.1617 -3.59582 -8.01118 +286 1 14.8948 2.98524 15.3712 -17.5751 0.764594 21.5491 +287 2 14.1876 2.34218 15.2724 -1.25262 -5.58382 2.64656 +288 2 15.4061 2.89645 14.5861 17.2961 2.13088 -20.5882 +289 1 9.89537 15.5662 16.9902 -4.09035 4.17693 9.89685 +290 2 10.2983 14.7234 16.7502 5.73332 1.10161 -2.59445 +291 2 9.67249 15.5035 17.9343 -2.60097 -1.56266 -9.87078 +292 1 11.3274 8.38795 16.5853 -21.4847 -13.5698 4.02619 +293 2 10.6433 7.93033 16.0536 12.1725 7.69909 5.41873 +294 2 11.2563 7.95351 17.4557 6.17465 6.37506 -11.4872 +295 1 3.9593 18.2162 16.7697 0.697619 -14.1615 -14.1273 +296 2 4.40283 17.477 17.2226 -3.01571 14.2153 3.03122 +297 2 3.77495 0.26362 17.3949 3.98021 5.349 11.1126 +298 1 2.22376 4.19593 8.92134 -23.2189 1.10906 -21.9008 +299 2 3.13693 4.25168 8.71451 27.6214 0.869066 -8.80864 +300 2 2.192 4.13003 9.85498 -3.77747 -6.53541 33.4183 +301 1 9.87956 10.3806 9.72418 15.1316 -34.7661 11.7533 +302 2 9.43202 11.1334 9.41625 -17.3542 37.4051 -17.5479 +303 2 10.0318 10.5223 10.6578 4.66737 -1.93825 10.7585 +304 1 9.70627 0.903434 10.8708 -16.6391 -17.8124 -8.64764 +305 2 9.32253 0.0380009 11.0933 9.22807 5.63208 7.52542 +306 2 9.08638 1.2149 10.1967 9.10725 8.78511 -0.274781 +307 1 9.19757 15.1031 10.2247 30.2853 16.2782 3.75492 +308 2 8.7691 15.7671 9.69642 -6.57671 14.9232 -6.79792 +309 2 8.58248 14.3993 10.2376 -24.9838 -23.9988 3.33467 +310 1 0.938497 9.56303 10.2766 -19.6808 1.12411 10.869 +311 2 0.864208 10.4264 10.69 -4.58503 2.29603 -0.877129 +312 2 1.8082 9.5891 9.92621 21.6362 -6.44505 -13.6115 +313 1 17.0002 4.85339 8.15215 21.2107 4.17599 -32.9154 +314 2 16.5226 5.60356 8.44909 -16.9553 23.1583 5.35412 +315 2 16.856 4.21761 8.81327 -1.81027 -27.4365 28.1652 +316 1 14.7301 14.7112 0.178334 14.6842 0.804622 -15.2869 +317 2 15.1474 15.2511 0.844024 6.42123 6.45952 11.8737 +318 2 13.9865 14.3021 0.591484 -20.7841 -7.92944 9.37323 +319 1 3.69091 11.0487 9.53568 5.98335 -8.96355 13.8332 +320 2 3.56651 11.2839 10.4631 4.16949 4.48414 3.3219 +321 2 3.23005 11.7193 9.04032 -8.2098 7.45463 -11.8198 +322 1 11.2005 10.7579 1.45634 -8.62161 -19.8695 4.90197 +323 2 11.5404 11.5862 1.17391 12.694 26.4047 -12.3165 +324 2 10.2904 10.7467 1.15081 -4.44873 -2.97897 0.910453 +325 1 13.1494 7.14877 12.735 25.4211 -2.46103 0.847156 +326 2 14.1287 7.02261 12.7655 -19.3043 2.68773 1.11168 +327 2 12.7806 6.27183 12.8763 -3.1166 -1.04351 -1.25783 +328 1 9.62343 1.89491 0.979311 -12.9604 6.63616 -29.4885 +329 2 8.7946 1.64267 0.49669 19.6199 4.62861 14.6045 +330 2 10.1494 2.42868 0.345455 -5.12075 -11.8177 11.3147 +331 1 10.6335 13.514 4.5646 -17.0056 -0.486025 -1.57099 +332 2 11.3585 12.913 4.68456 17.6411 -7.84828 -0.965736 +333 2 10.6299 14.042 5.36013 -0.769181 5.74096 10.189 +334 1 14.4133 1.73933 10.9414 -11.8391 -17.207 6.29742 +335 2 15.2077 1.35218 10.5638 5.14778 2.73806 -3.87278 +336 2 14.5015 2.69292 10.9149 5.22965 5.71868 -2.86675 +337 1 14.5722 12.1975 11.686 14.094 -1.05888 37.2495 +338 2 15.3017 12.3928 11.129 31.2021 7.92611 -10.369 +339 2 13.8916 12.0994 11.0714 -43.9062 -9.54665 -27.6985 +340 1 8.20779 5.06885 9.81189 17.2837 -27.279 -13.9945 +341 2 7.476 5.2926 10.3565 -21.7486 9.79802 13.7153 +342 2 8.11585 4.0945 9.69767 5.61634 21.6585 -4.44102 +343 1 1.51211 16.8659 18.4077 -7.21278 -21.5738 6.32543 +344 2 1.92778 17.2486 17.641 3.99023 3.9685 -12.2343 +345 2 1.4425 15.9033 18.1995 7.9863 23.2313 7.90302 +346 1 1.50475 17.27 15.3217 -52.6385 22.4638 18.049 +347 2 1.49283 18.1952 15.6793 7.67726 -26.1665 -10.1971 +348 2 0.544177 16.9836 15.4083 37.5739 4.67989 -9.3974 +349 1 3.64958 5.72975 6.08508 6.29069 -26.5723 -11.3796 +350 2 3.20343 6.25343 6.73323 -12.457 15.9806 12.721 +351 2 4.14586 6.29176 5.4852 3.70859 6.95385 1.18178 +352 1 12.4272 9.46789 14.1967 -22.2867 60.9428 4.59069 +353 2 12.8141 8.72569 13.8244 25.5413 -52.6107 -24.0302 +354 2 12.2248 9.22264 15.0865 -2.36671 -8.29514 20.866 +355 1 4.05215 15.2773 6.93811 -37.3363 -16.6714 15.1212 +356 2 3.52112 16.0418 6.69595 1.88806 4.21981 -3.16255 +357 2 4.93922 15.5036 6.7631 37.0693 10.9568 -7.31607 +358 1 0.634621 8.6113 14.9988 -1.00168 -8.57623 6.03626 +359 2 0.426563 9.53409 15.1284 -0.450123 11.8509 1.14186 +360 2 1.36493 8.60238 14.3834 7.02364 0.17651 -8.78598 +361 1 12.9488 8.28918 10.2591 -12.3232 2.05195 12.3522 +362 2 13.6164 7.77926 9.80228 8.67745 -2.84232 -3.45719 +363 2 12.9296 7.914 11.161 -0.920073 6.75149 -12.343 +364 1 15.3287 7.72887 3.53701 30.7324 40.0945 -27.1654 +365 2 14.5687 7.40616 3.08394 -23.025 -16.3354 4.19175 +366 2 15.5452 7.39964 4.39595 -10.5646 -17.2283 18.769 +367 1 17.3078 6.69366 0.0430756 19.9915 -9.88107 5.38445 +368 2 16.7705 5.94464 0.294276 -4.0765 -7.9871 3.32428 +369 2 16.6874 7.33606 18.3865 -21.7939 19.8828 -6.94939 +370 1 8.91017 6.93043 7.77699 23.4025 28.7729 -7.70378 +371 2 9.81824 7.33337 7.84479 -23.824 -15.1706 -1.9244 +372 2 8.86104 6.22236 8.40836 -0.772968 -13.4081 16.1446 +373 1 12.3843 0.611213 1.25908 1.98263 -0.697807 -4.79042 +374 2 13.323 0.393307 1.31761 -0.925839 8.32556 5.35041 +375 2 12.1237 0.465738 0.350227 -1.33982 -4.5367 -2.71568 +376 1 5.61465 15.1448 14.5392 -1.26631 -30.1046 6.25467 +377 2 4.66418 15.2406 14.6702 -0.2102 4.52428 0.84195 +378 2 5.97383 15.921 14.1393 5.11494 24.4221 -7.05072 +379 1 3.84895 6.44034 1.72963 2.7696 -8.11358 7.79979 +380 2 3.51864 7.3032 1.48291 -7.06055 11.1725 -5.60147 +381 2 3.99368 6.51729 2.68239 -0.0521329 1.22822 -5.4234 +382 1 3.90083 11.5778 12.3664 -12.9911 -8.32668 -3.5509 +383 2 4.78352 11.9371 12.4749 4.25232 1.56379 3.39016 +384 2 3.29545 12.1182 12.8978 7.28302 -2.19426 -6.07273 +385 1 5.34262 3.87885 15.873 -6.15348 -82.0204 -11.7996 +386 2 6.0076 3.23261 15.5032 -15.8888 19.1459 15.4213 +387 2 5.69117 4.71679 15.7838 27.5644 60.3601 -6.10452 +388 1 14.3156 10.2471 4.51115 -35.9806 40.7967 42.7391 +389 2 14.5125 9.92103 5.39777 -3.50802 -2.54983 -0.445713 +390 2 14.828 9.75135 3.94137 33.3968 -38.7315 -40.7643 +391 1 7.75287 17.3919 9.13705 13.5919 -13.2315 -4.02741 +392 2 6.89819 17.6363 9.44363 -21.9658 0.853712 16.3055 +393 2 7.88604 17.9611 8.38483 9.7933 6.77297 -11.9047 +394 1 4.50916 14.5069 3.91348 -1.14645 -26.1805 -53.139 +395 2 4.48781 15.3883 4.18695 -0.715057 47.311 12.47 +396 2 4.59583 14.0061 4.68593 4.03467 -28.7439 39.2156 +397 1 14.2649 7.40032 15.8248 -22.801 -12.9293 -21.4811 +398 2 15.1988 7.32934 15.7188 25.9215 -1.64325 -3.33443 +399 2 14.1282 7.83404 16.6492 -0.714938 9.98648 22.5393 +400 1 3.02257 18.338 1.93829 -9.63799 -32.7056 -36.1055 +401 2 2.55646 17.7535 1.2554 15.187 19.9859 31.9951 +402 2 2.37728 0.279403 2.32429 -11.6166 9.08866 3.80637 +403 1 7.9856 1.63208 4.58686 -21.2194 7.37107 -10.8429 +404 2 7.46714 2.08087 3.89599 -2.9365 -3.17783 11.7342 +405 2 8.82293 1.5175 4.16848 19.7493 -4.53145 -2.81354 +406 1 2.46603 14.1528 17.6814 26.4379 24.7021 -16.3984 +407 2 1.84119 13.6421 18.1459 -27.3849 -25.1212 16.5566 +408 2 3.3203 13.7773 17.9154 6.17156 -2.74614 2.81365 +409 1 0.847673 1.77812 13.8995 -29.1857 4.71799 7.40329 +410 2 0.70153 1.57851 14.8469 9.71331 1.1605 -15.3576 +411 2 18.5888 1.96886 13.5517 20.2657 -3.94578 7.10705 +412 1 4.44078 18.6823 13.9019 -16.0244 4.84661 7.61196 +413 2 5.30649 18.3093 13.8135 20.8517 -5.19628 -2.25594 +414 2 4.21344 18.5423 14.8331 -2.2181 0.553195 -4.50589 +415 1 7.17333 0.707602 18.3659 18.5924 -14.7376 -19.2949 +416 2 7.29313 0.222373 17.5065 -5.17699 16.3575 23.4569 +417 2 6.28409 1.05221 18.4099 -11.4153 -0.902781 0.0516699 +418 1 16.0458 18.3995 13.9929 19.922 2.02833 15.0786 +419 2 15.1358 18.307 13.8248 -34.099 -5.52537 -15.9309 +420 2 16.0494 18.5146 14.948 8.19193 5.7614 4.60276 +421 1 10.1078 4.56818 16.2539 38.806 25.935 -8.65561 +422 2 11.0636 4.83663 16.0361 -35.078 -16.4147 14.4025 +423 2 10.0818 3.61692 16.3176 2.43484 -11.3153 -3.34335 +424 1 15.9163 17.7591 4.46968 32.0074 -29.6155 -15.1132 +425 2 16.5099 -0.143617 4.50341 7.95185 14.4383 0.237761 +426 2 15.1003 18.0575 4.79025 -43.3278 16.7712 13.4837 +427 1 7.00774 17.4246 13.8321 -56.0949 -7.97771 -22.4327 +428 2 7.49162 17.6994 14.5684 25.5375 13.311 41.1471 +429 2 7.64463 17.2266 13.1734 23.6351 -3.93018 -21.4132 +430 1 13.2756 6.47326 6.61789 23.4956 20.1255 -14.8261 +431 2 14.0898 6.99784 6.40679 -18.3755 -16.6425 15.9473 +432 2 12.9103 6.33261 5.73881 -7.54238 -3.20295 2.17295 +433 1 7.79764 2.32743 9.30513 0.620653 -0.611916 41.3127 +434 2 7.26457 2.16571 10.1169 11.5422 6.28076 -11.6799 +435 2 7.22158 2.07024 8.60986 -14.5852 -6.72752 -26.4814 +436 1 15.1722 14.8472 13.687 6.75051 -12.1688 -2.41191 +437 2 14.9232 15.197 14.5358 -2.94711 1.82763 14.9216 +438 2 14.8185 15.4404 13.0388 -8.36185 8.62669 -11.0165 +439 1 9.38377 8.31795 3.7734 -21.5197 15.3047 -10.1967 +440 2 10.1883 8.66352 4.14356 14.5642 4.86611 3.27566 +441 2 9.4002 7.3753 3.8765 5.94621 -16.0238 5.03493 +442 1 17.77 13.5913 16.4331 -7.58631 -31.5789 18.0626 +443 2 16.8485 13.2919 16.3991 0.887673 4.05725 -0.920823 +444 2 17.783 14.4232 15.9937 -0.095827 22.773 -14.6224 +445 1 4.93053 10.5741 2.80353 -17.5831 18.6377 -10.1976 +446 2 5.6584 10.2884 3.33403 15.5926 -12.1878 10.3648 +447 2 4.56303 11.3186 3.30761 3.36544 -9.45409 -4.10473 +448 1 3.72361 8.36764 10.1215 3.29328 14.9495 -8.98506 +449 2 3.89363 9.29817 9.8724 -2.16289 -13.6958 -0.787578 +450 2 3.61222 8.39575 11.0685 -3.0862 -1.08413 10.2171 +451 1 15.9739 6.97387 6.06952 -13.2047 20.7109 0.201327 +452 2 16.7663 7.43242 6.33309 11.9845 5.69104 3.28059 +453 2 16.2425 6.10629 5.81378 6.71976 -25.6546 -0.898294 +454 1 15.1226 7.10933 9.08497 -8.54326 -39.6564 44.8588 +455 2 15.7377 7.52152 9.6861 12.0306 8.12876 4.18876 +456 2 15.1451 7.58697 8.30383 2.04885 32.3579 -51.8464 +457 1 6.29947 12.9646 12.7695 3.37722 -4.66482 -6.66232 +458 2 7.17165 12.6249 12.9809 1.24175 -10.0492 1.61343 +459 2 6.12977 13.6114 13.4445 -6.34808 15.4581 9.54933 +460 1 12.1164 4.51054 13.0962 -37.6646 -34.1548 1.17408 +461 2 12.2607 4.59773 14.0409 7.03003 6.16295 4.50476 +462 2 11.318 3.89029 13.036 30.5495 29.2935 -6.64922 +463 1 11.3767 8.15056 7.89733 -18.501 8.72492 -14.0328 +464 2 11.9999 7.57003 7.45959 11.3303 -6.40222 -0.944592 +465 2 11.6722 8.28384 8.79215 9.56916 -2.23029 14.0742 +466 1 17.1624 10.8628 7.5038 -34.939 16.2827 29.0255 +467 2 17.7665 10.1757 7.31962 29.6392 -23.074 -13.6235 +468 2 17.1223 11.4937 6.79065 1.17945 1.22203 -15.4432 +469 1 5.28569 18.1322 10.989 31.979 0.201705 -2.44437 +470 2 4.81806 17.865 11.7612 -14.4656 -7.34411 17.8618 +471 2 4.63582 18.2948 10.3295 -20.6991 2.34913 -21.9288 +472 1 7.59755 17.5197 1.78957 -4.56355 -5.70379 -23.6831 +473 2 7.90081 16.7255 1.29504 -6.23989 15.492 10.1621 +474 2 7.18064 18.108 1.12072 15.1074 -6.58967 11.1205 +475 1 1.93009 12.8809 13.5782 -3.15102 -7.76664 -18.9393 +476 2 1.45787 12.3423 14.2065 -6.90584 -5.9659 9.51664 +477 2 2.19823 13.666 14.0335 5.43227 17.0545 14.7464 +478 1 9.58089 6.76558 14.8178 3.72821 -35.8509 -10.9213 +479 2 9.75861 5.80832 15.0417 -6.66727 32.4051 0.0155959 +480 2 9.77461 6.83059 13.8656 0.408011 6.2359 8.07479 +481 1 15.2957 4.27102 10.7659 9.27088 14.9202 31.1326 +482 2 16.1322 3.95288 11.1528 -7.49935 1.06904 -21.0932 +483 2 15.0846 4.9939 11.387 -3.9034 -8.13187 -14.3813 +484 1 11.2455 6.18064 0.162868 26.0255 26.7031 14.5737 +485 2 11.4763 5.37121 18.3763 -4.81733 -21.4086 -8.3593 +486 2 10.308 6.3098 0.211594 -20.2553 -5.22819 -8.60243 +487 1 0.00824002 11.3791 15.0352 26.3856 -8.14992 32.1511 +488 2 18.096 11.5216 14.3022 -25.0888 8.62779 -34.0528 +489 2 -0.201285 12.127 15.606 2.8625 2.75044 1.90901 +490 1 7.02689 9.25213 7.27678 19.2929 16.5016 -4.78745 +491 2 6.59278 8.51389 7.67295 -14.5933 -20.8184 8.5158 +492 2 7.9603 9.00351 7.26624 -3.73747 1.30273 -1.02295 +493 1 18.3276 15.3446 12.3362 -3.78489 -4.33158 3.75643 +494 2 0.608087 15.5074 12.1532 11.0792 5.95639 -3.98767 +495 2 17.812 15.8736 11.72 0.968766 1.6464 -4.64437 +496 1 16.5183 4.40219 5.2766 -9.25512 24.5768 -59.2644 +497 2 16.7942 3.98653 6.05327 18.9035 -16.7679 44.3388 +498 2 17.2936 4.55111 4.6869 -10.7937 -7.24122 14.527 +499 1 17.7074 3.16435 10.7411 -7.07567 -19.8863 -1.17515 +500 2 18.5775 3.40914 11.0222 18.8337 10.6004 6.41913 +501 2 17.8312 2.27039 10.3862 -7.09349 4.4518 -2.20884 +502 1 12.3002 -0.0151335 10.1074 11.0606 -47.8945 -14.4391 +503 2 11.4203 0.251866 10.2671 -34.8312 14.3717 9.25421 +504 2 12.8296 0.729107 10.2725 26.3435 36.9272 6.71278 +505 1 10.377 9.78 12.4264 -19.0889 -11.9366 -11.7107 +506 2 11.0349 9.79085 13.1125 14.2042 0.527855 9.4859 +507 2 10.1856 8.83311 12.286 4.63513 11.4958 0.11243 +508 1 0.612468 2.80552 7.03105 -3.16196 -18.6605 -12.6623 +509 2 0.888173 3.44011 7.68312 3.89236 7.11247 14.3448 +510 2 0.935234 1.94488 7.34043 -2.08916 10.0979 2.30791 +511 1 0.333274 15.3197 6.88029 -14.1577 45.9776 55.0939 +512 2 0.45846 14.8119 7.69617 1.50982 5.91417 -3.14315 +513 2 0.483825 14.7581 6.18064 16.8578 -51.3136 -47.9608 +514 1 17.0479 7.0004 15.1603 7.32733 3.15391 4.0553 +515 2 17.7743 7.62519 15.0492 -4.65368 3.90748 -3.79045 +516 2 17.4843 6.26113 15.5911 -6.30626 -9.6282 -1.63315 +517 1 9.09335 12.4409 8.06571 39.5186 -12.5139 -7.54936 +518 2 9.34597 11.7249 7.45783 10.9221 9.9246 5.15013 +519 2 8.17581 12.4072 7.99758 -53.4732 7.6014 3.58329 +520 1 1.26136 1.81045 2.95361 -2.6705 2.40839 8.80735 +521 2 0.548126 2.01955 2.35817 -5.69651 1.92544 -13.4687 +522 2 1.50342 2.66138 3.33407 8.35517 -3.762 3.05283 +523 1 4.10861 15.1005 9.87028 17.6559 -3.6711 -5.25272 +524 2 3.99986 15.4157 8.96812 -4.49733 0.314881 -1.79245 +525 2 5.04559 14.8362 9.90181 -11.0653 1.71965 6.05025 +526 1 7.3044 2.18074 14.6544 -4.4599 -5.38687 1.90914 +527 2 7.13921 1.65822 13.8561 -1.41133 5.62984 3.30149 +528 2 7.58548 3.05039 14.3636 5.58134 3.87352 -5.39735 +529 1 18.5311 14.6245 2.16796 -28.4168 7.73599 -0.688338 +530 2 0.75601 15.0339 2.21782 2.27339 5.70314 -0.294719 +531 2 17.8249 15.3246 2.17516 22.0369 -13.9852 -0.651534 +532 1 9.98569 2.74939 12.8982 -9.19221 10.3282 12.793 +533 2 9.83979 2.05829 12.2602 3.07064 -9.86428 -11.8695 +534 2 9.16543 3.26718 12.8794 9.24196 0.527571 1.01071 +535 1 2.93657 8.90297 13.0427 17.8365 13.1008 0.527628 +536 2 3.20967 9.8454 12.9227 -4.18066 -20.4527 0.554358 +537 2 3.74278 8.43516 13.3493 -16.2822 5.83343 -3.94486 +538 1 3.21464 8.50963 3.72772 0.0178718 14.8284 -74.1155 +539 2 3.59865 9.33251 3.32895 -6.0017 -25.5341 4.84747 +540 2 3.33657 8.62148 4.62381 5.38554 5.83243 67.2306 +541 1 5.61344 7.20035 8.58446 -2.8239 -8.19112 0.0562215 +542 2 5.53456 6.24006 8.54079 8.61958 1.67382 -4.34837 +543 2 5.04066 7.41711 9.32304 -1.21443 9.5719 0.536432 +544 1 14.8964 1.44105 1.93253 -7.61412 -10.5809 19.4064 +545 2 14.4541 2.19461 2.37874 12.2686 -5.42452 -16.4906 +546 2 15.2548 1.628 1.06483 0.86569 15.045 -4.43663 +547 1 8.4154 15.1546 0.810786 1.70028 1.58395 -11.225 +548 2 9.17382 15.0707 1.40016 -1.99176 -3.13146 6.02583 +549 2 7.70673 14.5929 1.15135 2.54266 -0.476233 4.63029 +550 1 15.567 1.36482 7.20444 28.1778 15.3746 16.2283 +551 2 15.0185 0.765154 6.74682 -23.3742 -21.8939 -17.7163 +552 2 14.9729 1.99808 7.60632 -6.19001 12.1291 -0.330309 +553 1 5.0089 13.0207 18.4853 -18.4609 -5.74542 -15.9738 +554 2 5.42479 13.0864 0.690362 9.95106 2.52519 17.0862 +555 2 5.65544 13.3331 17.8473 1.85993 1.51979 0.712767 +556 1 15.3671 8.54929 18.1095 -8.15636 -15.968 22.0227 +557 2 15.6817 9.03573 17.3686 11.3034 18.5085 -22.2724 +558 2 15.31 9.18561 0.190372 -2.38163 -0.236806 -1.34825 +559 1 12.0802 3.07221 18.3457 4.60183 -13.894 -6.42275 +560 2 12.4859 2.4 0.260392 -4.96838 8.65649 13.1594 +561 2 12.2775 2.7013 17.4791 -3.58827 6.63097 -2.22236 +562 1 13.1993 12.6855 5.15579 5.61247 -4.39703 15.9491 +563 2 13.8115 11.9693 4.94018 -5.07495 0.365899 -6.13845 +564 2 13.2564 12.743 6.12308 -1.32671 2.90452 -5.88021 +565 1 6.08204 7.19061 0.120725 -6.90673 14.7019 -8.65455 +566 2 5.87336 8.13986 -0.0835188 5.89552 -25.7895 13.7146 +567 2 5.2676 6.79179 0.465292 5.04542 5.75855 -0.526985 +568 1 17.7014 15.9063 14.9696 22.6091 -4.25312 7.62853 +569 2 16.8618 16.3646 15.0156 -4.32677 -2.50983 -14.3551 +570 2 17.9392 15.6583 14.0532 -15.4152 10.9643 9.19951 +571 1 13.1673 0.955706 16.6058 -16.4624 13.9879 0.0318296 +572 2 14.0199 0.765403 16.9805 16.2653 -3.85138 1.37902 +573 2 12.7278 0.106773 16.5459 -0.203322 -8.12911 -4.60325 +574 1 10.9967 14.5844 7.33958 -18.0316 -21.646 7.99268 +575 2 10.1705 14.1548 7.70673 29.6081 10.2394 -10.7243 +576 2 11.7328 13.9554 7.47718 -10.5059 7.23567 0.829732 +577 1 17.5629 8.52802 2.09087 -9.01192 -26.3923 -8.78708 +578 2 16.6633 8.41226 2.4486 12.6056 4.50253 0.467713 +579 2 17.6588 7.73531 1.50133 0.834193 24.7006 12.2923 +580 1 12.3809 7.87992 1.9744 6.05515 -15.9846 -5.53898 +581 2 11.7749 8.59773 2.10936 -4.35558 14.0343 4.46215 +582 2 11.9629 7.32605 1.30246 4.89043 0.565697 0.45699 +583 1 11.9793 14.6347 10.4335 18.2405 9.923 28.253 +584 2 12.2756 14.1199 9.71871 15.2703 -21.0335 -29.0838 +585 2 11.0615 14.7405 10.2767 -32.5541 7.66631 -1.56623 +586 1 6.81522 6.956 15.5295 -17.6641 -14.7432 -7.98444 +587 2 7.71149 6.86909 15.2553 24.3623 -4.30517 -12.3513 +588 2 6.87971 7.6292 16.1782 -5.40685 18.4787 21.7047 +589 1 8.03389 4.5887 13.4155 -37.171 -3.64226 -22.5123 +590 2 7.25568 4.78495 12.82 23.9185 -7.87368 18.6792 +591 2 8.43341 5.43391 13.5743 6.319 9.72574 1.79505 +592 1 13.4002 12.1853 14.3374 -4.54681 1.91445 -1.84351 +593 2 13.053 11.3082 14.1695 -1.05297 -9.08012 2.89826 +594 2 13.8525 12.4201 13.5231 2.34057 5.70396 -2.70792 +595 1 14.6576 9.49709 7.25838 9.71531 18.8932 28.1379 +596 2 15.5128 9.94191 7.46983 -15.999 -8.53149 -8.43731 +597 2 14.0596 9.76702 7.98865 8.11873 -7.0154 -18.3951 +598 1 12.7312 16.9238 3.19475 21.2814 -46.1617 -18.4213 +599 2 12.8913 17.1254 4.09275 6.71284 11.8391 31.6773 +600 2 12.0991 17.5238 2.88672 -32.0955 36.7838 -15.6883 +601 1 1.05963 7.10571 17.4007 12.4792 -13.0695 22.2141 +602 2 0.186546 7.34268 17.7101 -8.13154 -6.52047 1.59159 +603 2 1.15324 7.46505 16.5336 -1.37945 14.6986 -20.6467 +604 1 12.8789 5.0234 15.6828 -31.729 4.63914 -0.239626 +605 2 13.551 4.37036 15.6981 25.2388 -22.1242 0.0408259 +606 2 13.353 5.8465 15.7229 6.14669 17.5754 0.411177 +607 1 2.40704 3.36861 5.12193 5.52974 -41.8871 -53.5671 +608 2 1.82145 3.26591 5.8288 -30.6852 -8.64892 41.0269 +609 2 2.78115 4.20498 5.20734 26.4804 50.2953 11.9131 +610 1 8.27515 11.124 13.5771 -2.85187 11.2881 -70.0801 +611 2 8.37295 10.8581 14.431 -1.92558 -15.2628 85.0569 +612 2 8.99363 10.6344 13.1748 6.72692 3.2721 -14.9 +613 1 12.918 1.48119 13.2724 -5.46048 -28.9446 23.2516 +614 2 13.637 1.39783 12.6661 14.6279 -0.945194 -20.1211 +615 2 12.6406 2.36931 13.1901 -10.8983 31.3672 -5.19186 +616 1 6.50945 13.6334 2.15016 9.54562 -3.73103 -23.7728 +617 2 5.85792 13.9589 2.75542 -11.9505 6.96003 17.098 +618 2 7.07728 13.0286 2.63475 0.813075 1.46302 3.43305 +619 1 15.9192 6.52891 12.704 16.1802 17.7634 -8.70325 +620 2 16.3422 7.10874 12.0232 -9.40583 -17.3352 17.4966 +621 2 16.4304 6.67694 13.5293 -11.6709 -4.5663 -12.9766 +622 1 16.8012 0.7168 9.58424 5.37965 28.6432 5.104 +623 2 16.9134 18.4317 9.69441 -4.13374 -28.9785 4.85106 +624 2 16.4797 0.860059 8.69243 -6.31121 -1.15561 -8.50241 +625 1 6.13999 11.6637 8.32406 3.84263 60.0529 3.8669 +626 2 5.34748 11.493 8.80779 -22.31 -6.18549 9.45125 +627 2 6.46273 10.8378 8.08078 19.7827 -51.2376 -16.1138 +628 1 2.82548 8.7059 0.356008 25.1404 7.14145 17.7175 +629 2 2.1872 8.20684 18.5458 -21.47 -27.2684 -27.7438 +630 2 2.28201 9.37487 0.754925 -1.41085 15.0233 10.6798 +631 1 10.1039 10.4509 6.57992 -4.79526 -6.25674 7.70278 +632 2 10.5083 9.74309 7.09516 2.94215 -0.723708 0.948173 +633 2 10.6276 10.5201 5.78606 4.97834 -0.717699 -12.6856 +634 1 6.77313 15.7547 6.63388 -5.578 -17.4503 -5.92282 +635 2 7.15743 16.0375 7.46176 7.11582 8.10879 3.23091 +636 2 7.28529 16.1142 5.89948 -1.84538 11.4125 4.1387 +637 1 6.44197 13.0281 5.69829 11.2984 8.90971 -1.05733 +638 2 6.79679 13.8886 5.97631 -5.91305 -5.55439 0.155281 +639 2 6.12445 12.6032 6.49753 -3.74834 -3.51916 3.00547 +640 1 16.7803 12.5246 9.7433 1.48678 16.9805 10.4147 +641 2 16.9869 12.0132 8.97443 1.49858 -19.0548 -12.8116 +642 2 17.3026 13.3224 9.61445 -4.02823 0.499055 5.20393 +643 1 6.14077 2.94238 2.79674 5.90568 12.9134 -1.15866 +644 2 6.37771 3.87334 2.54509 -6.86675 -27.0997 0.367621 +645 2 5.77601 2.45475 2.03942 1.6023 9.98348 0.439644 +646 1 10.8329 3.18005 3.24633 -5.48645 -3.34604 -3.46544 +647 2 10.1887 3.87164 3.40992 -1.49044 3.74393 4.82403 +648 2 10.5052 2.73309 2.45537 3.4248 -0.0323397 2.60803 +ITEM: TIMESTEP +60 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.78901 6.89398 17.9776 -3.5234 1.93788 3.89787 +2 2 7.91305 7.05712 18.3419 -1.4277 0.241332 2.63834 +3 2 8.67661 6.15674 17.3832 1.3639 -6.15529 -7.04239 +4 1 18.7561 8.31771 6.77309 10.5748 -7.50476 -33.4266 +5 2 0.457617 7.9886 5.89382 -17.7288 16.9324 23.762 +6 2 0.568724 7.76979 7.40723 1.86737 -7.24646 12.6232 +7 1 8.51532 18.7703 6.84705 0.662358 -5.68449 9.56329 +8 2 9.4329 0.211311 6.58737 4.53489 1.21926 -2.36791 +9 2 8.05203 0.803554 6.35578 -1.87482 6.91549 -4.54998 +10 1 6.50103 1.76445 11.707 -23.9337 -6.76257 7.94266 +11 2 5.68898 2.17855 12.0897 23.4576 -7.00878 -10.5629 +12 2 6.21872 0.874053 11.3985 3.54415 20.4784 6.13886 +13 1 7.00577 5.62696 2.40487 20.8008 -18.6778 -13.9491 +14 2 6.3381 5.93149 2.99593 -12.7158 11.2498 18.9927 +15 2 6.96044 6.19487 1.63998 -3.33571 5.44078 -9.1088 +16 1 16.2317 10.2379 16.0906 -2.65398 7.02849 4.45196 +17 2 17.1094 10.623 16.0697 3.52116 -7.47169 -6.62031 +18 2 15.6835 10.996 16.3292 -1.12895 -7.31017 -0.603728 +19 1 10.664 14.9341 2.30567 13.0251 3.56406 6.3158 +20 2 10.7336 14.2976 3.03428 -5.34804 6.23285 -3.50086 +21 2 11.2229 15.6743 2.58509 -4.07292 -1.48419 -0.585019 +22 1 17.1728 8.23947 10.7128 -1.64499 -1.99855 0.608593 +23 2 16.6728 8.84067 11.2819 0.316783 0.889357 -0.63917 +24 2 17.9322 8.74349 10.3965 1.71935 0.329185 -1.07247 +25 1 14.697 15.9473 16.4368 -13.7705 -0.197196 -7.11694 +26 2 13.7879 16.279 16.3001 13.6207 -4.8592 3.02749 +27 2 14.6438 15.4158 17.2461 5.07545 7.5417 -4.99128 +28 1 12.1134 13.367 0.528093 -6.39608 9.01831 -4.72995 +29 2 11.8173 13.4954 18.2644 6.74141 -8.66363 -5.87361 +30 2 11.5587 13.987 1.01769 3.38254 -3.71164 8.60635 +31 1 9.30318 5.47999 3.94883 35.8178 1.45581 -2.5285 +32 2 8.76671 5.2044 4.67379 -16.9173 -4.15595 18.9992 +33 2 8.71572 5.58687 3.21666 -20.2172 1.55363 -14.8227 +34 1 1.70529 4.08306 11.601 -3.00308 -9.11056 -2.97947 +35 2 1.52513 4.97184 11.9147 2.37337 9.05749 0.600173 +36 2 2.22567 3.63839 12.2786 -1.82607 -0.283286 1.9059 +37 1 2.04499 6.82744 8.26893 9.18028 14.0429 7.96475 +38 2 2.5896 7.29904 8.93262 -11.3816 -6.25496 -6.31442 +39 2 1.81536 5.98181 8.67357 4.33854 0.450625 -3.71013 +40 1 5.3656 4.4774 7.93824 1.44041 9.72132 7.59831 +41 2 5.44269 3.52851 7.84762 -1.19648 -12.0175 -6.62376 +42 2 4.92598 4.83778 7.16432 -9.0894 -3.97332 -7.9273 +43 1 3.32251 2.9413 17.4443 0.538374 -34.3486 -6.77872 +44 2 3.98642 3.24962 16.8336 8.9197 7.73227 -3.39959 +45 2 3.04976 3.68399 17.9526 -12.2781 23.4468 13.5982 +46 1 7.437 5.38423 6.13063 5.01567 -0.272219 -26.6536 +47 2 7.97737 5.94965 6.66546 10.8347 10.076 12.8667 +48 2 6.99068 4.78917 6.71033 -9.3836 -11.0864 17.8628 +49 1 9.80479 7.01238 12.0379 -9.46641 4.39554 -21.4508 +50 2 10.3276 6.40912 11.4906 -4.30802 3.34771 7.14548 +51 2 9.13044 7.38666 11.4225 10.4612 -8.54147 15.485 +52 1 14.0024 3.65677 8.07153 1.90613 10.1899 13.6881 +53 2 13.9361 4.48059 7.56554 -1.4656 -7.0627 2.39316 +54 2 14.1946 3.93561 8.9889 0.417494 -3.38136 -15.0381 +55 1 4.51888 17.1453 3.95588 7.87944 -4.67708 3.20643 +56 2 5.41436 17.4585 3.90856 16.3959 1.38908 8.05638 +57 2 4.13204 17.4705 3.15493 -16.1768 7.51082 -11.5461 +58 1 16.4506 16.6012 10.3314 -28.9812 -6.12917 4.01051 +59 2 15.5905 16.5574 10.8183 20.4446 2.48532 -11.9951 +60 2 16.2667 16.1387 9.49338 0.364513 2.67256 9.91326 +61 1 1.97065 4.79938 0.260671 -8.10245 -17.5737 -13.0373 +62 2 2.41281 5.12274 1.03667 10.218 10.6244 9.40508 +63 2 1.8267 5.54768 -0.321227 -3.59337 9.6389 -0.147197 +64 1 11.5035 13.2586 16.3577 -0.713967 20.2415 12.8794 +65 2 11.0441 12.4305 16.4814 -6.19498 -9.28579 -2.23027 +66 2 12.0754 13.1484 15.6021 5.65191 -4.41955 -9.63321 +67 1 10.1276 11.0105 16.8449 -6.46201 16.5427 1.83518 +68 2 10.5556 10.1721 16.794 12.0656 -22.7421 -1.13044 +69 2 9.20289 10.8171 16.6996 -9.212 1.56961 -0.130134 +70 1 11.787 17.4505 13.4822 -3.74088 11.88 -4.97071 +71 2 12.2373 16.9277 12.8063 6.56705 3.4706 4.72845 +72 2 12.0251 18.3805 13.3063 -1.30808 -7.68873 2.97322 +73 1 6.42132 9.37259 12.2366 13.1698 8.24141 3.19081 +74 2 6.99069 9.01867 11.5406 -12.3498 -0.982732 4.41902 +75 2 7.03807 9.88277 12.7853 -8.70879 -2.27031 0.0855326 +76 1 16.2815 12.8722 2.70224 -2.02351 7.50879 0.830271 +77 2 17.1172 13.3658 2.56775 -16.1548 -5.18742 1.80773 +78 2 15.5334 13.5108 2.69253 18.3367 -6.33955 1.64103 +79 1 0.729913 12.6587 5.89268 5.90957 5.27776 3.54404 +80 2 1.01336 12.4973 4.99287 4.32656 -0.558571 -7.43154 +81 2 18.4322 12.7877 5.81211 -15.2269 -3.44557 0.704235 +82 1 5.2582 16.4249 18.4194 -10.384 10.1199 -1.35479 +83 2 5.6864 15.6785 18.0038 6.48963 -9.24773 3.62069 +84 2 5.52942 16.4885 0.694307 6.00107 -3.50652 -0.438993 +85 1 0.618748 7.72132 4.16911 -57.0293 -28.7954 36.7096 +86 2 18.6577 8.06272 3.52122 -10.6934 7.30065 -13.2418 +87 2 1.44908 7.88182 3.83946 68.942 18.8036 -26.9673 +88 1 3.13476 8.97804 6.4725 9.50813 11.9402 -13.0637 +89 2 3.74054 8.49646 7.01761 11.8689 -6.06991 10.2621 +90 2 2.28514 8.86225 6.86989 -19.244 -2.30506 4.89646 +91 1 7.29998 10.3842 16.2581 17.8205 -0.109318 -17.8263 +92 2 6.62843 10.5749 15.608 -5.58859 2.04705 -1.34953 +93 2 6.87201 10.3756 17.1052 -6.43011 -2.48695 12.6131 +94 1 11.0863 0.954938 5.00203 0.851153 5.26347 3.05665 +95 2 11.191 1.83687 4.62341 -3.02583 0.75042 -0.451702 +96 2 10.8235 0.406956 4.25776 -2.05383 -4.79736 -1.16032 +97 1 4.33613 2.85707 13.1911 1.54519 27.1095 -5.33994 +98 2 4.57692 3.1724 14.0657 0.352889 6.79614 0.336856 +99 2 4.2364 1.93118 13.308 -7.70759 -34.1778 4.58716 +100 1 8.4203 10.2079 1.80876 2.06346 -1.14808 -20.454 +101 2 8.303 10.9031 2.4489 -3.41662 7.51624 10.9075 +102 2 8.71506 9.44854 2.30018 2.97787 -12.0816 9.03727 +103 1 10.3977 1.70625 15.5267 1.73644 2.79304 1.06494 +104 2 11.3647 1.6343 15.5026 -8.09264 -2.44943 -3.11689 +105 2 10.0867 1.93234 14.6348 6.55478 -0.658466 2.12488 +106 1 2.65181 12.9273 7.85805 -0.311785 2.06689 -1.07798 +107 2 3.23228 13.5447 7.39928 3.74905 0.741997 1.40009 +108 2 1.98379 12.6968 7.20259 -0.999427 -0.794231 1.07688 +109 1 3.77953 11.641 5.00453 4.18201 7.36008 7.19136 +110 2 3.61117 10.803 5.43181 -1.00449 -4.29555 7.12479 +111 2 2.98088 11.8656 4.52857 -4.84381 -0.0516249 -5.594 +112 1 6.70671 14.4383 16.9441 -2.88793 7.65462 4.66357 +113 2 7.46032 14.9632 17.2378 1.25427 -2.15328 -4.6823 +114 2 6.29331 14.8741 16.1864 7.83964 -2.53039 -3.71142 +115 1 14.1974 14.5272 3.32557 -8.64957 0.126228 1.77541 +116 2 13.6145 15.2324 2.99689 6.18241 -4.15847 9.95625 +117 2 13.7792 14.1343 4.11346 2.7139 4.36583 -10.9531 +118 1 8.49626 18.0895 16.0579 -56.9361 5.6973 -1.31016 +119 2 8.97799 17.2887 16.1101 31.3098 -20.0295 7.70991 +120 2 8.99116 0.248943 16.0582 28.7181 13.2998 -3.6499 +121 1 4.72072 1.70195 4.90499 9.17194 -24.9679 14.1726 +122 2 3.98364 2.22531 5.16555 -23.8501 10.7625 5.04957 +123 2 5.10611 2.17516 4.19081 15.0133 13.348 -19.3674 +124 1 15.0233 12.5839 16.4881 -18.3113 17.2758 -0.569629 +125 2 14.531 13.0978 17.1312 10.6463 -2.17552 11.3526 +126 2 14.3728 12.5238 15.7796 8.99848 -7.00837 -8.88439 +127 1 15.6995 18.4783 16.8755 -18.8856 10.9503 -24.4051 +128 2 16.4938 18.4127 17.3644 26.3461 0.942046 24.9737 +129 2 15.418 17.5728 16.7613 -4.49112 -11.2036 -1.17338 +130 1 1.28835 1.23059 16.5761 -5.93248 -0.138309 0.14802 +131 2 2.13994 1.64325 16.7078 7.79309 6.58334 -0.470261 +132 2 0.740967 1.66098 17.2372 -5.253 -1.12337 3.85618 +133 1 18.1629 4.44327 15.9115 -6.79632 -1.27318 -1.28488 +134 2 18.1308 3.86521 15.1462 0.0573414 -0.0912133 -1.44422 +135 2 0.437875 4.54116 16.1499 5.78898 1.89854 1.50737 +136 1 12.2373 17.0002 16.1546 0.545523 9.79929 -13.3931 +137 2 11.4461 16.6427 16.5433 -11.0844 -6.7728 9.10484 +138 2 12.011 17.1373 15.2222 3.0182 -2.09591 3.06353 +139 1 16.0678 2.55904 18.1722 10.2246 -6.29614 14.7907 +140 2 15.8342 3.46829 18.3235 -8.81825 14.1289 4.59946 +141 2 15.8732 2.39245 17.2622 -4.4601 -2.08833 -19.809 +142 1 6.72425 13.805 10.1648 -2.60578 6.66979 -6.33116 +143 2 6.49371 13.5045 11.0525 -0.564993 -6.25943 -2.37403 +144 2 6.44263 13.1457 9.51237 3.71898 -2.3263 8.04067 +145 1 10.1796 18.3897 2.72456 -2.84724 -9.82946 6.47371 +146 2 10.454 0.395639 2.08514 4.83004 8.04726 -9.16723 +147 2 9.37175 18.0281 2.35385 -6.15379 0.681222 3.71385 +148 1 3.03584 17.7169 6.12875 -8.09623 -9.32203 -7.45056 +149 2 2.18289 17.4189 5.74043 17.1828 11.6191 3.33552 +150 2 3.689 17.6882 5.40781 -11.2408 2.0569 5.59443 +151 1 12.6056 16.8615 7.96971 24.61 3.09247 -20.49 +152 2 12.0094 16.1192 7.91607 -18.906 -3.75998 3.49802 +153 2 12.4208 17.4479 8.69718 -9.87831 1.59818 13.2946 +154 1 14.8851 15.258 8.17849 4.86996 1.69705 3.53461 +155 2 13.9994 15.6489 8.25275 11.2692 6.96129 -5.86816 +156 2 15.346 15.6481 7.40987 -12.7499 -9.2219 7.50011 +157 1 17.7579 18.2305 0.335063 13.8809 -6.66068 -7.77561 +158 2 18.5388 17.6427 0.115787 -18.9695 29.962 7.44433 +159 2 18.0215 0.522838 0.460167 3.90753 -19.2563 -2.82208 +160 1 0.789759 10.4825 1.35847 3.51968 14.2812 -7.72333 +161 2 0.0798625 9.88631 1.6077 -6.45512 -1.46576 0.207918 +162 2 0.407025 11.2033 0.810215 7.48025 -15.8311 11.8414 +163 1 1.75759 12.251 3.36651 -3.2997 0.800224 -5.24767 +164 2 1.53389 11.5715 2.69671 0.947411 14.52 5.02147 +165 2 1.90006 13.112 2.93145 -3.03991 -14.1386 -4.6936 +166 1 0.626528 17.2392 4.94747 0.535799 -10.8391 4.53682 +167 2 18.8821 18.137 4.96158 -2.27873 -17.8214 11.6149 +168 2 0.354378 16.6324 5.68648 2.97307 28.5848 -17.7586 +169 1 1.10952 0.863641 9.39152 -13.7339 -4.40866 12.9037 +170 2 1.31873 0.587529 10.3088 -1.45288 2.90017 -16.0983 +171 2 0.209028 0.525909 9.24512 10.3392 4.25606 -0.349363 +172 1 16.7392 2.34887 13.3076 6.86896 9.31967 14.159 +173 2 16.9447 2.54868 12.3949 -1.60073 1.25233 -7.99088 +174 2 16.5723 1.40956 13.3727 -4.20045 -10.3799 -4.26178 +175 1 2.67499 15.8791 12.0838 -15.6649 13.6026 18.6328 +176 2 3.08767 15.4473 12.8331 1.25238 -1.62775 -1.314 +177 2 3.09072 15.5563 11.2931 8.09534 -6.35014 -12.1736 +178 1 16.4274 15.6453 6.10859 -17.0431 -16.804 0.948824 +179 2 17.3058 15.6768 6.44562 21.0308 -4.79075 10.9 +180 2 16.4023 16.3397 5.46924 -8.03031 15.1286 -15.2988 +181 1 5.80151 5.1106 11.8034 -9.99749 12.6805 7.50019 +182 2 5.41461 5.91177 12.2246 6.41162 -14.9692 -6.22456 +183 2 5.12172 4.42339 11.8362 4.25931 3.80702 2.95737 +184 1 15.1575 4.86793 0.802761 22.7174 4.42582 -27.0135 +185 2 14.9254 4.50834 1.64009 -5.31496 -5.26411 26.4075 +186 2 14.3858 5.30472 0.469017 -12.1413 5.82456 -3.82743 +187 1 16.3769 16.3844 2.01422 -5.72057 14.22 1.10565 +188 2 15.9278 16.7493 2.80314 10.8683 -6.01604 -9.24812 +189 2 16.773 17.1531 1.56448 -5.22082 -7.76197 3.40899 +190 1 0.23965 4.83003 3.84895 -16.8427 -30.7507 -16.2196 +191 2 0.252698 5.75131 3.99923 2.34384 38.0203 4.84997 +192 2 0.859131 4.45396 4.45569 14.7994 -7.19156 9.40612 +193 1 2.95205 15.0559 15.135 12.255 2.89982 -34.0079 +194 2 2.82691 14.77 16.0276 -6.33331 -2.96333 21.8089 +195 2 2.70057 15.9867 15.0833 -9.42631 -1.00353 7.2626 +196 1 1.12786 14.6523 9.50314 0.137917 -12.6668 4.07712 +197 2 1.90226 14.1941 9.14772 -4.18616 2.58129 -2.64264 +198 2 0.826039 14.044 10.1958 0.138103 8.11094 -6.03497 +199 1 13.5191 16.5585 11.5327 7.73147 -8.17374 8.97592 +200 2 13.1298 17.2703 11.0385 -2.21772 17.726 -8.86187 +201 2 13.0359 15.7976 11.2032 2.83922 -8.38127 -1.58332 +202 1 4.66669 1.44213 0.750789 16.1276 9.43437 -4.32571 +203 2 4.14083 2.03292 0.213208 -5.20243 5.56453 -6.36037 +204 2 4.0469 0.85314 1.17877 -1.04658 -3.40534 3.74731 +205 1 1.47829 18.5621 11.858 5.51121 1.25702 19.3245 +206 2 1.35114 0.550992 12.5892 2.53269 -8.70306 -5.34898 +207 2 2.06733 17.8728 12.2103 -6.7512 4.69931 -6.32602 +208 1 11.4685 10.1386 3.99675 -31.6511 -19.8648 40.1611 +209 2 11.3534 10.4173 3.11507 -1.88937 16.5167 -32.0622 +210 2 12.3922 10.1317 4.15588 31.92 0.339396 6.83567 +211 1 8.2329 12.185 3.6562 14.6677 -4.21505 -16.0366 +212 2 9.0609 12.5679 3.94713 7.11932 4.3628 2.52934 +213 2 7.63223 12.3212 4.36927 -17.6963 1.05811 24.4992 +214 1 14.5368 4.0151 3.29112 -13.123 -7.80297 -23.8392 +215 2 15.0981 3.94713 4.04639 13.729 3.5857 20.4451 +216 2 13.7669 4.51912 3.55347 -6.0046 4.6829 5.42155 +217 1 5.65486 1.65777 7.52148 58.4475 40.9395 -13.9317 +218 2 4.99661 1.25201 7.99959 -53.8788 -37.1346 38.2946 +219 2 5.51095 1.40377 6.61889 -5.49301 1.61126 -19.8188 +220 1 17.8901 1.045 4.84749 -9.94718 -16.9222 0.488244 +221 2 18.5122 1.52388 4.30334 5.34684 7.49098 -3.2278 +222 2 17.6047 1.57034 5.59464 4.63979 8.2364 3.24002 +223 1 6.81309 9.39039 4.50819 3.0131 -8.49785 6.19054 +224 2 6.80308 9.57416 5.46384 1.81054 -3.72037 -9.62081 +225 2 7.68859 9.02244 4.29465 -5.74329 4.97879 4.89484 +226 1 2.5752 14.8387 1.99973 -14.8295 0.871449 -1.75437 +227 2 3.26878 14.7632 2.65166 10.803 -1.54702 2.65568 +228 2 2.97003 14.8559 1.12279 1.99123 -2.02101 2.0261 +229 1 17.298 12.9204 13.1492 -3.4846 16.1956 -6.51124 +230 2 16.423 13.308 13.3278 8.68723 -6.18077 0.438899 +231 2 17.8438 13.7012 12.9334 -6.61166 -12.0077 2.21466 +232 1 14.9034 10.5534 1.40093 -1.35277 29.2651 19.5565 +233 2 15.388 11.3453 1.77149 -13.4573 -26.0533 -12.1606 +234 2 13.9634 10.6773 1.62965 16.0361 -2.08776 -5.28169 +235 1 5.72986 6.65162 4.58435 -17.0557 15.5593 -6.14164 +236 2 5.84842 7.61417 4.55049 3.33824 -4.32419 -0.681988 +237 2 6.28697 6.32726 5.29234 8.09232 -2.61709 -0.816212 +238 1 7.99944 8.35521 10.3848 17.9936 -2.63811 -6.27588 +239 2 8.59251 9.07404 10.0893 -6.48701 -11.154 -5.32581 +240 2 7.88909 7.71789 9.66296 -2.42609 11.6503 -0.200638 +241 1 13.4241 18.44 5.69275 23.5538 0.0525075 -9.71433 +242 2 12.6953 0.391603 5.53139 -12.0458 3.72648 -1.32391 +243 2 13.2482 18.017 6.52624 -8.74326 -11.7295 10.7578 +244 1 0.0158155 2.64508 0.27395 14.5716 -58.678 15.8132 +245 2 17.7841 2.79898 -0.0392974 -21.1138 14.4347 -10.6776 +246 2 0.56739 3.397 0.238244 13.7063 38.8805 -4.38724 +247 1 12.8888 11.0203 9.74081 14.4921 -25.5472 6.65601 +248 2 11.9442 11.0265 9.60333 -9.9467 -3.56544 -1.05488 +249 2 13.1018 10.1085 10.0646 -8.85698 19.3484 -7.35591 +250 1 0.676749 12.1402 11.0769 -15.7222 13.4662 19.3247 +251 2 18.361 12.1632 11.2371 5.51909 -2.16069 -8.49445 +252 2 1.03381 12.419 11.9274 8.68848 0.134808 -1.80861 +253 1 5.1281 7.32638 13.4074 12.574 7.81643 0.126088 +254 2 5.56178 8.11083 13.0117 -0.574951 -12.9077 2.36295 +255 2 5.67541 7.10745 14.1812 -7.25639 3.83801 -6.5213 +256 1 1.19691 6.83481 11.9192 5.63437 23.0857 0.0567084 +257 2 0.430704 7.22717 11.4609 12.0202 -4.44614 6.83847 +258 2 1.80476 7.59103 12.1282 -18.5438 -19.7012 -5.0003 +259 1 15.5112 9.6605 12.308 7.39931 -23.3592 2.14975 +260 2 15.3284 10.5626 12.1388 -11.1565 28.2269 -10.7029 +261 2 15.46 9.608 13.2546 2.72926 -7.26454 12.4411 +262 1 16.5981 12.7055 5.55132 5.93792 -6.99565 4.13948 +263 2 16.3871 13.6216 5.72312 -3.40713 11.8574 1.85996 +264 2 16.4508 12.5854 4.61105 -1.1211 0.407027 -8.19974 +265 1 6.341 9.80883 0.0188309 -5.87145 18.2236 11.3739 +266 2 5.58583 10.3592 0.271383 3.51693 -3.70717 1.01998 +267 2 6.97723 9.90576 0.746734 -2.19026 0.0209431 -7.09875 +268 1 12.2976 6.11648 4.05009 -7.99316 6.14403 -18.1211 +269 2 12.258 6.83685 3.38221 3.50754 -15.1435 11.6411 +270 2 11.4736 5.62673 3.91242 4.22123 1.1153 4.56647 +271 1 0.341758 12.8367 0.152932 -4.41368 -4.71323 -6.18075 +272 2 -0.071293 13.3938 0.818389 4.38543 6.64898 2.3316 +273 2 18.4831 12.9746 17.9873 -4.56942 3.87447 -1.94524 +274 1 3.61813 18.6313 8.61443 0.661139 8.76689 2.03667 +275 2 3.46056 18.3752 7.69711 -0.554223 -6.30588 2.24303 +276 2 2.77043 0.354615 8.90695 5.13325 -4.08936 -2.3138 +277 1 7.42355 17.3409 4.4768 -7.56741 1.42105 -0.716546 +278 2 7.51902 18.2689 4.68925 3.30463 5.13228 6.51734 +279 2 7.58206 17.32 3.5353 -0.521854 -4.80047 -8.50069 +280 1 9.24832 17.1301 12.2139 -13.1815 7.8308 -4.22869 +281 2 9.33905 16.301 11.7591 -2.0028 -14.1862 -9.75618 +282 2 10.0447 17.2202 12.718 16.3553 3.99578 13.5609 +283 1 13.2894 13.0415 8.03267 8.35671 10.0486 -9.41069 +284 2 13.3695 12.1786 8.4589 5.84428 6.69767 4.94138 +285 2 14.1604 13.5085 8.0433 -18.6948 -10.3528 3.9365 +286 1 14.8481 2.99092 15.3927 0.856118 4.40098 19.7153 +287 2 14.1706 2.3196 15.3374 -5.14829 -8.82459 -5.54141 +288 2 15.3789 2.92995 14.603 5.00888 -0.952448 -11.2281 +289 1 9.90287 15.5907 16.9887 3.86064 7.54266 0.708681 +290 2 10.4376 14.8321 16.7196 -3.05759 -5.14225 0.11478 +291 2 9.69704 15.4836 17.9287 -2.19155 -3.5869 -5.21272 +292 1 11.3068 8.44228 16.6046 -8.18504 -5.87812 -2.49231 +293 2 10.7375 7.86962 16.0559 4.371 7.7216 8.33293 +294 2 11.2933 8.06373 17.4959 1.16379 -1.60832 -8.83864 +295 1 4.00007 18.2264 16.7774 4.24494 10.2639 17.5421 +296 2 4.56172 17.6396 17.2965 -1.57319 -6.32646 -5.9019 +297 2 3.85664 0.302165 17.4089 -1.12143 -0.586814 -11.7526 +298 1 2.2479 4.22742 8.91978 -15.7964 -0.236851 -9.315 +299 2 3.17417 4.26053 8.71033 14.3134 -0.385935 -1.23962 +300 2 2.16897 4.01078 9.84529 1.80454 -0.809508 12.1296 +301 1 9.87751 10.3883 9.74788 10.9603 -30.3507 -6.41167 +302 2 9.55849 11.2198 9.44401 -12.062 25.9436 -6.06801 +303 2 10.0779 10.4258 10.6774 1.92757 5.46095 17.7276 +304 1 9.69765 0.927205 10.8701 14.9831 -0.992619 -3.75191 +305 2 9.43595 0.039964 11.1566 -10.0783 4.56951 -4.94264 +306 2 9.12787 1.25731 10.1583 -1.53115 -8.98556 4.28196 +307 1 9.19006 15.088 10.2066 22.8811 13.4843 7.03893 +308 2 8.82905 15.9231 9.90375 -5.23887 5.212 -7.88342 +309 2 8.4517 14.4971 10.2333 -16.9878 -12.2258 -0.936878 +310 1 0.910091 9.64474 10.2618 6.35784 -25.2235 -17.0921 +311 2 0.848571 10.4636 10.7331 2.68282 16.4495 1.28733 +312 2 1.6853 9.71195 9.67503 -11.8234 -0.16557 12.5577 +313 1 17.0493 4.85425 8.1315 23.124 -12.0189 -22.071 +314 2 16.5036 5.57379 8.38464 -19.6085 19.0848 9.20549 +315 2 17.0051 4.2127 8.82658 -1.69519 -7.20825 12.6053 +316 1 14.7684 14.7087 0.123438 -2.69691 -12.5371 -11.3918 +317 2 15.061 15.3506 0.758659 10.1685 10.0196 13.4831 +318 2 13.9556 14.337 0.462955 -8.28455 -4.39651 5.72223 +319 1 3.75153 11.0481 9.53582 4.71209 -10.2499 1.98044 +320 2 3.63189 11.3357 10.4456 -0.734234 5.70871 5.17654 +321 2 3.24354 11.632 8.96907 -2.43681 8.8531 -2.47663 +322 1 11.2519 10.7463 1.5017 8.48932 -12.5201 -0.266865 +323 2 11.5908 11.5519 1.12329 1.64528 14.0457 -7.10687 +324 2 10.3311 10.688 1.26079 -12.3399 1.77059 -3.9568 +325 1 13.1496 7.17281 12.6854 5.50111 -7.8338 2.87732 +326 2 14.101 6.95885 12.7444 -10.2033 1.82309 -0.47089 +327 2 12.6663 6.34751 12.851 5.63542 3.55 -1.50526 +328 1 9.61828 1.90104 0.967862 -1.73511 6.80555 -16.7575 +329 2 8.75126 1.82608 0.511852 18.7109 -2.38487 5.6602 +330 2 10.2637 2.29933 0.349253 -13.3131 -4.11214 4.99441 +331 1 10.6435 13.4896 4.54607 -8.3754 1.2658 -1.96254 +332 2 11.4795 13.0515 4.69791 8.28938 -6.58305 0.731496 +333 2 10.5798 14.1432 5.24738 -1.32643 -0.553656 5.74704 +334 1 14.4543 1.71115 10.9546 -7.69161 -4.81009 -3.91494 +335 2 15.2136 1.28396 10.5547 4.80162 -2.13195 -1.67599 +336 2 14.6015 2.65135 10.8079 -1.60778 0.935868 6.54178 +337 1 14.5384 12.1186 11.6682 4.42158 0.0609916 50.1985 +338 2 15.3244 12.3738 11.2188 19.3883 10.0258 -22.7848 +339 2 13.838 12.0043 11.0592 -19.2299 -5.1918 -28.9193 +340 1 8.19636 5.07775 9.81895 6.92668 -2.08004 -5.22277 +341 2 7.38544 5.24812 10.3055 -3.33886 -3.05544 1.61921 +342 2 8.19204 4.12852 9.59915 -2.53054 10.0553 1.98192 +343 1 1.48663 16.8897 18.439 7.38955 -7.44055 -8.00122 +344 2 1.97341 17.2271 17.6702 -6.10601 -1.16576 3.12224 +345 2 1.43805 15.9298 18.2902 4.85843 10.0488 4.15854 +346 1 1.49392 17.3013 15.324 -13.7543 10.7593 4.06087 +347 2 1.44447 18.24 15.6259 -3.67575 -24.1287 -4.86768 +348 2 0.590882 16.9129 15.3122 14.6177 13.551 2.26757 +349 1 3.61646 5.75696 6.06482 3.05275 -16.2413 -2.75756 +350 2 3.17 6.32551 6.68313 -10.4039 6.81614 9.87761 +351 2 4.1613 6.3181 5.51248 5.12466 2.54076 -5.58469 +352 1 12.4579 9.47416 14.2028 -15.1686 39.1263 4.59508 +353 2 12.91 8.74193 13.8564 21.0065 -34.4741 -21.4004 +354 2 12.311 9.21984 15.1046 -5.21536 -3.05923 17.073 +355 1 4.05954 15.2722 6.9713 -12.2847 -13.6907 9.03639 +356 2 3.52733 16.0267 6.71946 -3.69787 8.1984 -1.38185 +357 2 4.94462 15.4979 6.70957 17.3953 3.39893 0.124931 +358 1 0.676716 8.64845 15.0435 0.0448789 -8.8726 2.29819 +359 2 0.388517 9.55355 15.1457 -0.102902 11.258 0.0552156 +360 2 1.38121 8.67263 14.3922 3.78483 -0.0353447 -4.44966 +361 1 12.9131 8.29224 10.2146 2.07907 -10.3878 2.68575 +362 2 13.6346 7.78925 9.80195 -2.79275 5.95566 3.91371 +363 2 12.8029 7.87463 11.0885 3.60602 9.09063 -7.955 +364 1 15.3505 7.77425 3.51602 -25.105 2.18251 -0.815364 +365 2 14.4666 7.51634 3.2857 -7.66712 2.41401 -31.383 +366 2 15.2516 7.5997 4.43625 29.5189 -3.75051 28.1293 +367 1 17.2908 6.71242 0.0288264 8.4359 -0.0595562 3.38218 +368 2 16.7481 6.02838 0.414195 -4.41494 -10.5616 1.77026 +369 2 16.6696 7.39667 18.4317 -9.71571 9.06541 -4.14994 +370 1 8.93558 6.94317 7.77066 11.3734 11.9101 1.30985 +371 2 9.8513 7.28708 7.82315 -13.5624 -4.9569 -0.419932 +372 2 8.83457 6.3282 8.49913 -0.351333 -9.82053 6.39411 +373 1 12.3886 0.605922 1.26733 4.3474 1.63423 -5.64369 +374 2 13.3496 0.62067 1.39833 -3.50709 5.26207 -1.10414 +375 2 12.2365 0.554465 0.317002 3.44844 -5.08055 2.164 +376 1 5.6093 15.1332 14.5298 5.50237 -6.63524 -3.85361 +377 2 4.67729 15.3131 14.6547 -7.5977 -3.56809 4.17708 +378 2 5.99198 15.9265 14.1501 5.33744 7.17763 0.920224 +379 1 3.83862 6.42399 1.72255 -0.530245 0.761181 6.81888 +380 2 3.42185 7.23588 1.41886 -3.5948 7.2146 -3.68667 +381 2 3.94102 6.55655 2.67261 0.00170673 0.796504 -2.59346 +382 1 3.90756 11.5263 12.3817 0.20855 -7.47029 -8.65749 +383 2 4.79535 11.8927 12.4625 -0.681042 -1.53834 0.918823 +384 2 3.33577 12.1179 12.8713 -4.93373 1.57702 0.731635 +385 1 5.31593 3.88159 15.8542 -0.71358 -42.6288 -12.177 +386 2 5.97198 3.22378 15.5406 -6.31298 7.40988 7.32158 +387 2 5.73536 4.71214 15.7787 14.3185 32.9857 -0.935745 +388 1 14.2562 10.2258 4.56557 -18.8652 24.4894 6.04548 +389 2 14.4389 9.92543 5.45169 -1.13053 -5.88778 11.8213 +390 2 14.6954 9.63367 3.98806 17.1426 -20.2086 -20.2139 +391 1 7.6892 17.381 9.10447 19.4711 -25.2283 0.682627 +392 2 6.86971 17.6207 9.51632 -14.1206 10.5396 4.24559 +393 2 7.90224 17.9622 8.37374 -3.5427 12.2774 -4.18627 +394 1 4.51373 14.5018 3.89084 0.522587 -13.0056 -37.966 +395 2 4.5996 15.4052 4.14706 0.258928 20.2029 10.6105 +396 2 4.49773 13.963 4.65868 1.58881 -14.8294 26.2191 +397 1 14.2556 7.39762 15.8429 -9.24001 -8.17606 -10.1746 +398 2 15.1854 7.31956 15.6389 10.3704 -1.38951 -4.38862 +399 2 14.2355 7.83779 16.6857 -0.295639 4.56275 12.5602 +400 1 3.05453 18.3862 1.94671 -28.337 -27.777 -22.0693 +401 2 2.58101 17.7651 1.32015 15.7039 17.8808 20.6311 +402 2 2.35293 0.259745 2.36363 3.01847 1.93426 2.5363 +403 1 7.98344 1.63895 4.58298 -1.95289 -5.65456 5.83277 +404 2 7.39472 2.00993 3.91227 5.60846 -0.877805 -3.34347 +405 2 8.83104 1.39808 4.18815 -5.23209 5.3786 -4.6966 +406 1 2.44155 14.16 17.683 19.8901 20.6744 -11.1998 +407 2 1.71949 13.6284 17.9614 -19.7639 -16.6874 11.6615 +408 2 3.22651 13.6749 17.9404 10.3416 -4.56611 4.09925 +409 1 0.874431 1.8172 13.9017 -2.66591 2.98819 0.0720706 +410 2 0.796895 1.67216 14.8604 0.805718 -0.9226 -9.7327 +411 2 18.6311 1.96655 13.5402 2.6832 0.103556 9.2189 +412 1 4.40474 18.7103 13.8903 -4.51489 2.73844 -3.11833 +413 2 5.26066 18.332 13.6843 10.2731 -0.629088 3.90858 +414 2 4.27285 18.5624 14.8326 -2.10334 -1.04281 2.89108 +415 1 7.22541 0.768378 18.3802 -7.41292 5.22253 -10.0414 +416 2 7.14919 0.357851 17.5011 6.06274 3.8916 10.097 +417 2 6.39657 1.25171 18.5223 1.70256 -10.1891 2.75464 +418 1 16.0038 18.3833 13.9769 4.60778 -2.90009 -16.1733 +419 2 15.0678 18.3553 13.7682 -2.12799 2.80836 4.60244 +420 2 16.1189 18.6995 14.8699 -6.8859 -1.5785 15.9997 +421 1 10.1619 4.59436 16.2508 34.7775 -10.6887 1.26028 +422 2 11.1678 4.58362 16.2281 -36.3206 4.79489 -1.20103 +423 2 9.8959 3.67942 16.0718 3.3051 4.94693 0.644026 +424 1 15.9268 17.7185 4.48585 -0.443376 -19.9814 -7.77196 +425 2 16.5546 -0.221465 4.56619 12.2284 16.6263 -2.03126 +426 2 15.0862 18.0786 4.73637 -15.899 7.019 6.15678 +427 1 6.9987 17.4508 13.864 -28.5259 -4.03497 -9.84039 +428 2 7.52153 17.7102 14.6061 10.1765 7.77338 18.9538 +429 2 7.63162 17.2858 13.1766 11.9873 -1.11294 -13.1093 +430 1 13.256 6.47431 6.57718 13.0919 -2.27803 2.33044 +431 2 14.2181 6.68617 6.52776 -23.2683 -1.75779 -6.09518 +432 2 12.9031 6.34478 5.6793 8.47748 2.51219 6.97161 +433 1 7.82324 2.30197 9.35649 6.58131 4.23212 14.3466 +434 2 7.32826 2.17284 10.185 -1.16662 2.6949 -8.43976 +435 2 7.24342 2.0875 8.62812 -8.03625 -5.88123 -5.84644 +436 1 15.1686 14.8419 13.6961 6.6084 -8.9126 -6.67367 +437 2 14.8499 15.0658 14.5674 -3.29174 5.55862 10.3748 +438 2 14.9102 15.5355 13.091 -7.311 3.85237 -1.87114 +439 1 9.39203 8.3247 3.79765 -11.0731 4.19637 -5.3616 +440 2 10.2213 8.76913 3.95172 10.5135 8.75123 3.89829 +441 2 9.56922 7.39926 3.9554 -1.92777 -9.54221 1.11885 +442 1 17.7628 13.6056 16.4368 0.454101 -14.0132 9.10192 +443 2 16.8123 13.4442 16.4542 -1.43638 -1.23592 -2.30674 +444 2 17.8812 14.4042 15.9249 -1.89469 7.90276 -3.85648 +445 1 4.90818 10.546 2.83916 0.136377 -2.73925 -10.4847 +446 2 5.60998 10.1288 3.34488 4.96678 -0.616571 0.115447 +447 2 4.51664 11.1769 3.44738 0.912314 1.46625 2.09919 +448 1 3.71104 8.38719 10.068 0.753133 0.0228827 -3.76935 +449 2 3.89927 9.29887 9.80067 -2.70003 -3.09285 3.15772 +450 2 3.67512 8.396 11.0298 -2.24059 1.87779 0.37074 +451 1 15.9565 6.94095 5.99865 -8.76526 9.77307 4.96327 +452 2 16.7516 7.41234 6.24421 7.68049 3.9133 2.85915 +453 2 16.2393 6.06165 5.75492 3.70751 -7.34759 -2.0072 +454 1 15.1339 7.14501 9.07066 -1.17949 -23.8082 27.0602 +455 2 15.8283 7.58235 9.55517 11.4438 5.0236 10.3868 +456 2 15.1116 7.57875 8.25013 -4.20744 20.1878 -38.3409 +457 1 6.25297 12.9267 12.7452 -4.72449 1.01458 -5.57239 +458 2 6.98991 12.3599 12.9819 6.62509 -1.61272 7.49964 +459 2 6.12032 13.5727 13.4468 2.47956 2.45399 3.39123 +460 1 12.1116 4.51066 13.1059 -15.4407 -10.6836 -10.9314 +461 2 12.4271 4.59486 14.0171 -10.4637 -2.65404 1.19035 +462 2 11.2547 4.00523 13.0473 26.1752 13.1928 8.83048 +463 1 11.3958 8.13336 7.91828 -4.43196 -2.05658 -14.2843 +464 2 11.9753 7.54394 7.4184 3.39578 1.92795 -0.521112 +465 2 11.8257 8.23937 8.76441 1.22007 0.905858 11.3028 +466 1 17.1296 10.8754 7.54699 -15.2323 -0.655909 3.97588 +467 2 17.811 10.2663 7.31344 17.8297 -18.4071 -0.448075 +468 2 16.9935 11.379 6.74844 -4.7697 12.6356 -6.62113 +469 1 5.29547 18.1363 10.9421 18.5805 -0.935137 -5.10578 +470 2 4.88577 17.8485 11.7431 -9.76906 -7.6723 14.1577 +471 2 4.62403 18.0611 10.2783 -13.9129 1.88822 -17.2145 +472 1 7.59234 17.5076 1.75687 4.86523 1.07577 -14.9702 +473 2 8.00304 16.7666 1.28453 -8.52174 0.253094 2.89961 +474 2 7.35564 18.1425 1.05706 3.89665 -2.44167 8.83688 +475 1 1.92302 12.8778 13.5789 2.91886 3.94981 -7.24471 +476 2 1.45818 12.4106 14.2651 -5.47786 -10.2367 6.99308 +477 2 2.33812 13.6191 14.0211 -0.459782 9.91978 4.14062 +478 1 9.50973 6.75636 14.7983 0.267759 -13.8501 3.13598 +479 2 9.76861 5.87974 15.1842 -3.78976 20.025 -16.8859 +480 2 9.67323 6.78366 13.8359 6.07296 -1.5477 12.5306 +481 1 15.3007 4.25662 10.7816 1.6835 6.93604 -0.852744 +482 2 16.2201 3.94716 10.8841 -13.758 11.9338 1.00514 +483 2 15.2044 5.07319 11.3041 5.68258 -12.2185 -1.66994 +484 1 11.2682 6.20917 0.148653 5.11845 2.03204 -0.614283 +485 2 11.4613 5.3156 18.5351 10.8417 -13.6045 -1.35957 +486 2 10.3344 6.26425 -0.02153 -13.2524 10.0913 1.35666 +487 1 -0.0515508 11.3921 15.0043 28.8186 -12.3739 35.7691 +488 2 18.1888 11.7008 14.2289 -27.1505 12.4881 -39.8426 +489 2 -0.144753 12.1488 15.5889 -3.39882 3.34168 7.51926 +490 1 7.01363 9.26741 7.30523 1.11866 9.50703 -8.15996 +491 2 6.64493 8.42979 7.58084 -4.10674 -7.85165 7.60391 +492 2 7.94964 9.11568 7.16987 5.72986 -2.82238 2.51511 +493 1 18.3266 15.3189 12.3109 1.98396 7.8422 -1.62162 +494 2 0.557814 15.686 12.1521 7.34904 -2.57966 -0.481227 +495 2 17.7488 15.821 11.7275 -2.3238 -0.409324 -3.46342 +496 1 16.5074 4.41847 5.29023 -12.2776 2.5176 -39.1335 +497 2 16.8214 4.00292 6.06235 10.453 -12.003 36.2431 +498 2 17.1989 4.29433 4.62557 3.70164 8.40848 3.22117 +499 1 17.7062 3.18115 10.7633 -10.0415 -0.498888 0.968384 +500 2 18.5829 3.451 11.0307 13.8857 -2.29821 0.377097 +501 2 17.7544 2.33603 10.3089 5.51555 -4.87272 -1.50428 +502 1 12.31 -0.0249004 10.0958 7.06597 -29.3992 -7.90418 +503 2 11.4091 0.228435 10.2265 -21.0592 11.9526 6.39906 +504 2 12.8361 0.735194 10.2786 15.1995 22.0824 4.66414 +505 1 10.3672 9.76964 12.4555 1.27225 -3.68083 -7.54967 +506 2 11.1341 9.82258 13.035 0.839453 -0.704743 2.83749 +507 2 10.2702 8.82174 12.2801 -0.554943 5.543 3.04928 +508 1 0.65465 2.77798 7.04528 -2.13863 -3.2199 7.00126 +509 2 0.891211 3.42266 7.72053 -0.0150652 2.55779 -0.825415 +510 2 0.990123 1.95336 7.40694 -1.54003 -2.33595 0.508806 +511 1 0.295674 15.3348 6.84982 -3.22172 27.5014 26.3495 +512 2 0.521244 15.1551 7.76985 -0.748412 3.60522 3.47657 +513 2 0.484365 14.5358 6.4159 11.6769 -37.1534 -21.5269 +514 1 17.0573 6.99129 15.1128 -10.0859 0.519269 -2.81001 +515 2 17.7626 7.64158 14.9811 2.36054 -7.88383 3.70046 +516 2 17.4128 6.20418 15.5441 6.5971 2.49163 -1.29874 +517 1 9.10445 12.4501 8.04005 25.0355 12.8023 20.768 +518 2 9.46092 11.7782 7.45434 -7.91968 -3.65307 -8.74082 +519 2 8.16829 12.5393 7.95206 -19.3694 -6.70788 -7.44718 +520 1 1.22811 1.76814 2.9182 -6.11732 -10.0295 -0.237983 +521 2 0.712195 2.08081 2.16479 2.12402 6.69579 0.750032 +522 2 1.58605 2.52034 3.3947 3.99278 5.86411 -0.360805 +523 1 4.10894 15.0956 9.93451 6.69744 -1.75099 -1.18621 +524 2 3.96901 15.3261 9.00671 4.91376 -1.44666 0.188494 +525 2 5.04659 14.871 10.0423 -6.23862 1.0691 -5.37016 +526 1 7.35274 2.18983 14.6875 -7.358 8.13743 -4.11606 +527 2 7.08638 1.65776 13.9297 0.32385 -1.91134 2.32143 +528 2 7.57979 3.04743 14.3014 5.83731 -4.25907 3.58957 +529 1 18.4915 14.5922 2.16266 -14.7631 20.4811 3.31696 +530 2 0.685462 15.0501 2.31645 0.801171 -7.89169 -2.84158 +531 2 17.8141 15.3012 2.20781 8.07106 -12.7893 -1.48401 +532 1 9.99475 2.73128 12.8993 -0.14498 6.34622 4.34107 +533 2 9.94968 2.10764 12.1674 -2.02697 0.25981 -1.25528 +534 2 9.23805 3.32791 12.8055 1.37719 -5.85529 0.104676 +535 1 2.96937 8.88969 13.0348 8.45161 15.4602 -1.6792 +536 2 3.19044 9.8379 12.866 -0.537566 -21.2484 3.2835 +537 2 3.7799 8.47356 13.3849 -14.589 3.50084 -4.12479 +538 1 3.21 8.56161 3.75492 -0.42537 -8.47878 -37.7314 +539 2 3.66747 9.30861 3.32521 -2.76458 -7.90594 7.43156 +540 2 3.22415 8.6869 4.6856 3.07128 8.62247 25.8231 +541 1 5.62342 7.20688 8.60781 8.60088 8.53717 -11.0276 +542 2 5.53536 6.26871 8.41561 -2.891 -1.4677 7.62716 +543 2 4.92494 7.48858 9.21156 2.86443 -6.54236 0.635755 +544 1 14.9008 1.47426 1.89198 -2.54888 27.9205 4.61998 +545 2 14.5535 2.29499 2.28075 -2.57285 -15.9361 9.92214 +546 2 15.4844 1.8547 1.23467 3.18874 -15.0862 -12.382 +547 1 8.48736 15.1158 0.783841 -1.15568 2.93173 4.22404 +548 2 9.1238 15.1934 1.5071 4.62293 -5.62872 -5.40551 +549 2 7.79285 14.5509 1.14844 -2.73481 2.50701 -2.31707 +550 1 15.539 1.37952 7.19688 19.4515 3.6409 9.83231 +551 2 14.9389 0.78101 6.7773 -13.8468 -10.3512 -10.8641 +552 2 15.0003 2.07296 7.57775 -6.55979 11.3773 -1.03994 +553 1 5.01034 12.9912 18.4705 -11.9235 -4.12885 0.570622 +554 2 5.4698 12.9987 0.669061 0.312037 0.832023 7.43214 +555 2 5.59011 13.4721 17.8825 4.88062 -0.262691 -5.03625 +556 1 15.3764 8.57785 18.0866 -6.62354 -11.676 10.0569 +557 2 15.6805 9.14973 17.3909 9.52323 10.3388 -11.2321 +558 2 15.2475 9.1488 0.206008 -1.03261 3.33477 1.75561 +559 1 12.066 3.08414 18.3349 -10.3405 10.2428 -1.58162 +560 2 12.3601 2.47993 0.38654 4.70786 -1.39849 -7.75748 +561 2 12.2507 2.72995 17.4495 4.61736 -8.1861 15.8047 +562 1 13.1968 12.6883 5.15757 -0.336282 2.96846 2.60586 +563 2 13.7743 11.9999 4.79412 -5.71366 -0.326721 6.52296 +564 2 13.1697 12.5812 6.12031 6.45904 1.498 -4.43193 +565 1 6.0986 7.21596 0.138974 -12.0498 11.3036 0.237585 +566 2 5.91833 8.16028 -0.0709607 9.65884 -21.2748 10.0237 +567 2 5.34258 6.95155 0.690129 5.85049 -3.44248 -7.26534 +568 1 17.7044 15.8891 14.9714 -7.43083 8.66678 -26.2685 +569 2 16.7907 16.1885 14.8618 6.06094 -1.91119 12.6189 +570 2 17.95 15.7638 14.036 5.46338 -3.82161 12.7361 +571 1 13.1509 0.939295 16.6327 -8.19033 8.72571 -1.54201 +572 2 14.0859 0.833936 16.7968 10.9207 -0.957234 5.29932 +573 2 12.8431 0.0418051 16.5014 -5.83506 -5.32332 -1.35137 +574 1 10.9522 14.5534 7.35938 -9.11436 -19.3925 22.6665 +575 2 10.1531 14.2304 7.85485 20.6615 9.00594 -18.4516 +576 2 11.6365 13.8859 7.56325 -5.91964 10.2955 -7.71128 +577 1 17.5919 8.49388 2.10024 -0.0322199 -9.95032 2.76416 +578 2 16.7206 8.43914 2.53345 10.0393 -1.69965 -6.58888 +579 2 17.6862 7.68098 1.5623 -5.40062 15.1321 4.16518 +580 1 12.403 7.83298 1.98454 10.1699 2.43182 8.97059 +581 2 11.823 8.58837 2.10452 -0.914469 2.41145 -5.63632 +582 2 12.0432 7.27751 1.28772 -5.41827 0.0907324 -1.12401 +583 1 12.0169 14.6214 10.4613 22.6496 -4.80377 11.9203 +584 2 12.2953 14.2566 9.62296 -0.627137 -3.48742 -6.53871 +585 2 11.0904 14.7922 10.4232 -26.4922 1.86569 -7.97999 +586 1 6.79945 6.92747 15.5042 -19.94 -13.6896 0.562857 +587 2 7.71181 6.85747 15.2524 19.187 5.43316 -2.40109 +588 2 6.75196 7.52139 16.2502 2.78602 4.81827 4.32857 +589 1 8.02489 4.54706 13.3799 -9.17747 17.7449 0.879178 +590 2 7.13549 4.71954 13.0119 14.9133 -0.721221 -4.30494 +591 2 8.45659 5.41872 13.4818 -10.582 -17.269 -1.29002 +592 1 13.3893 12.1928 14.3557 -6.07818 9.44403 7.21842 +593 2 12.9754 11.3343 14.2402 3.84433 -8.34325 -3.30791 +594 2 13.789 12.4346 13.5154 0.839467 -1.50598 -4.68274 +595 1 14.6037 9.51924 7.26293 11.3016 8.32374 8.02904 +596 2 15.4883 9.92697 7.3747 -13.533 -2.89904 3.77438 +597 2 14.03 9.85877 7.96896 6.22863 -2.20078 -8.30261 +598 1 12.724 16.8794 3.24165 4.36843 -29.0517 -11.6906 +599 2 12.9143 17.2056 4.10583 4.58985 8.72699 22.0136 +600 2 12.2764 17.5776 2.79705 -13.1015 20.2627 -13.4405 +601 1 1.027 7.08618 17.3856 17.8688 -9.35062 9.83545 +602 2 0.150845 7.20834 17.7372 -11.0357 -5.72224 6.2597 +603 2 1.04228 7.56687 16.5674 -0.430665 10.2682 -15.3686 +604 1 12.9047 4.96423 15.6783 -31.9319 9.90183 -0.420667 +605 2 13.6101 4.38571 15.8945 27.3027 -16.194 0.870052 +606 2 13.2534 5.85423 15.7473 6.89498 8.57473 1.28829 +607 1 2.36359 3.37095 5.13131 13.5367 -21.0772 -51.8355 +608 2 1.78827 3.18983 5.83511 -26.0337 -9.2034 36.1161 +609 2 2.76982 4.19309 5.31063 16.9607 33.0577 11.3338 +610 1 8.25673 11.0457 13.6214 -29.0742 18.4766 -42.051 +611 2 8.3505 10.9269 14.5387 12.3752 -9.07103 37.7912 +612 2 9.04494 10.7715 13.1556 11.3248 -9.59576 5.23465 +613 1 12.933 1.51857 13.2538 -7.42773 -10.5209 16.1392 +614 2 13.555 1.47666 12.536 9.8649 3.44918 -12.9241 +615 2 12.6435 2.43109 13.2999 -2.22529 4.34734 -4.74481 +616 1 6.5593 13.6321 2.14465 -6.91915 6.53865 -12.6846 +617 2 5.89828 13.9136 2.78341 -2.94652 3.12599 2.20918 +618 2 7.14809 13.061 2.63026 6.2374 -5.23981 3.14213 +619 1 15.8933 6.50668 12.6624 16.2584 4.45316 -6.00807 +620 2 16.3963 7.03445 12.007 -8.38894 -8.88658 12.5353 +621 2 16.4415 6.50555 13.4748 -12.028 3.27562 -10.9527 +622 1 16.7983 0.717045 9.56947 3.68169 11.9749 4.12436 +623 2 16.6133 18.4601 9.81273 2.15246 -18.3954 6.85595 +624 2 16.3759 0.833391 8.71872 -3.66349 3.7587 -11.8412 +625 1 6.14397 11.6556 8.30338 8.0817 56.4015 -2.32443 +626 2 5.40727 11.3941 8.82366 -25.1595 -10.6153 12.4164 +627 2 6.54205 10.8782 7.99323 17.2725 -41.4748 -11.5815 +628 1 2.81032 8.69956 0.356218 24.742 -6.25 8.21391 +629 2 2.27105 8.19016 18.4013 -14.5977 -1.17978 -6.66412 +630 2 2.29881 9.42159 0.72289 -11.078 1.63045 0.198871 +631 1 10.1064 10.4292 6.59515 -4.60438 -3.93729 0.830471 +632 2 10.5227 9.70923 7.07758 4.69601 -3.0134 2.20114 +633 2 10.434 10.3774 5.69507 4.10481 0.747976 -4.90006 +634 1 6.80466 15.7541 6.67201 6.06476 3.31695 -2.74514 +635 2 7.12474 16.199 7.46137 -2.48244 -3.95514 6.52968 +636 2 7.21004 16.2686 5.96286 -5.79252 -2.21211 -4.39766 +637 1 6.45958 12.986 5.74076 6.97467 7.4921 0.177054 +638 2 6.67553 13.8767 6.05203 0.11849 -2.56514 -0.0944634 +639 2 6.15828 12.5051 6.51647 -3.32664 -1.56183 1.61673 +640 1 16.774 12.5213 9.71798 -12.6143 2.89661 19.2402 +641 2 17.0082 11.8947 9.03708 5.67192 -3.35034 -8.73073 +642 2 17.3962 13.2453 9.69208 4.02202 2.48097 -6.52464 +643 1 6.17384 2.92225 2.79448 3.9775 16.0199 -22.3947 +644 2 6.54801 3.78326 2.49667 -7.94175 -14.5768 11.9424 +645 2 5.69703 2.59738 2.01124 2.48224 -4.95439 10.1002 +646 1 10.7977 3.13994 3.23713 3.9771 -4.26255 2.57443 +647 2 10.0782 3.73781 3.45741 -0.0760182 2.97522 -1.01161 +648 2 10.5069 2.61778 2.47973 -3.48459 4.35709 1.40724 +ITEM: TIMESTEP +70 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.80152 6.81783 17.9876 -13.1435 8.65537 6.0931 +2 2 7.93927 7.0215 18.3978 9.39494 -6.73756 -6.11522 +3 2 8.64173 6.15327 17.319 -1.79792 -4.8767 -3.2487 +4 1 0.159104 8.33212 6.75565 -1.75886 1.86255 -0.283403 +5 2 0.400553 7.98898 5.87058 -1.56937 3.6046 13.6337 +6 2 0.532733 7.75931 7.44677 0.588181 -1.3305 -10.9259 +7 1 8.56014 0.2064 6.86713 15.1827 -2.1442 1.30375 +8 2 9.48839 0.201881 6.58247 -8.47619 -0.963055 4.35965 +9 2 8.1657 0.891093 6.32874 -5.18544 5.82437 -2.7504 +10 1 6.48158 1.74839 11.7303 -5.73112 -6.99234 -4.49671 +11 2 5.77966 2.25139 12.1582 1.03612 1.63173 -0.79005 +12 2 6.04661 0.9684 11.3341 5.10627 10.6526 7.94811 +13 1 6.96595 5.58057 2.38836 1.68885 13.6464 8.05547 +14 2 6.50498 5.94206 3.17078 2.94101 -7.34901 -12.8293 +15 2 6.93975 6.29059 1.72807 -1.07971 -9.74986 0.444847 +16 1 16.2371 10.2379 16.1019 -30.9876 -7.62323 7.88585 +17 2 17.0175 10.5802 15.7054 20.7335 11.057 -7.58035 +18 2 15.6477 10.9912 16.2983 15.508 -10.4523 -2.02188 +19 1 10.7008 14.9379 2.28795 4.31472 -8.51672 3.50984 +20 2 10.6635 14.2367 2.95607 -1.08681 7.31624 0.965 +21 2 11.2207 15.6296 2.69467 3.48557 9.19098 3.66151 +22 1 17.1795 8.23023 10.7992 8.53416 -1.59534 -8.67541 +23 2 16.5643 8.83199 11.2261 -1.39923 4.26423 7.56567 +24 2 17.9421 8.77596 10.5426 -4.34729 -3.75626 -0.741474 +25 1 14.6688 15.978 16.4285 2.33326 -11.9168 -2.20454 +26 2 13.7825 16.2968 16.2522 -6.84331 1.16869 1.85073 +27 2 14.5784 15.3806 17.1932 6.40998 12.5602 -6.81985 +28 1 12.1084 13.347 0.550082 18.7888 -12.4001 5.31554 +29 2 11.808 13.4241 18.2861 -6.00468 7.05887 -5.4437 +30 2 11.724 14.0175 1.12482 -9.88619 2.03399 -6.75529 +31 1 9.30709 5.48775 3.90966 3.41698 -5.29876 17.2174 +32 2 8.77877 5.25688 4.68667 5.61339 2.83044 3.00189 +33 2 8.64592 5.55872 3.2299 -8.10772 2.16644 -16.0449 +34 1 1.64595 4.02425 11.592 -10.9656 22.1289 -13.9701 +35 2 1.60629 4.97108 11.8395 -0.824037 -11.4025 -3.90562 +36 2 2.20491 3.59841 12.2231 10.5337 -11.1868 16.6964 +37 1 2.06621 6.87149 8.22737 1.24172 3.77126 1.52806 +38 2 2.50304 7.30143 8.97949 -2.75541 -3.2118 -2.64013 +39 2 1.97282 5.93715 8.45613 -0.171499 4.52155 4.26063 +40 1 5.3374 4.4954 7.902 -9.99384 -2.48662 -4.40208 +41 2 5.3873 3.53885 7.92862 5.32096 -10.0353 0.506932 +42 2 4.78906 4.68538 7.13029 -0.632429 8.18831 0.496784 +43 1 3.33945 2.92164 17.4119 -9.04777 -8.0172 12.2496 +44 2 4.01569 3.37904 16.9228 10.8208 5.2633 -7.4392 +45 2 2.90871 3.59334 17.9575 0.609467 0.189965 -2.29637 +46 1 7.45919 5.40741 6.16401 6.01334 0.147035 -1.33637 +47 2 7.84933 5.9815 6.83711 3.51741 -4.84398 -5.3698 +48 2 7.00259 4.70355 6.63733 -2.11297 5.93299 1.70682 +49 1 9.81228 7.01862 12.0561 -1.06857 0.870105 -3.24483 +50 2 10.2542 6.3375 11.5392 -2.78202 1.90065 -0.0845581 +51 2 9.1292 7.39963 11.4807 2.35361 -4.5728 1.86322 +52 1 13.9947 3.68643 8.08173 -5.65395 18.5094 -17.1015 +53 2 13.7843 4.54079 7.64233 1.50666 -18.9 8.64197 +54 2 14.1479 3.8993 9.00085 4.5059 2.7709 6.99075 +55 1 4.5073 17.1442 3.93435 4.48768 -12.0008 8.39889 +56 2 5.39081 17.5321 3.92633 -2.26089 2.72179 -5.35255 +57 2 4.01543 17.3459 3.13072 5.98217 13.0117 -0.399635 +58 1 16.4079 16.585 10.4121 -12.3499 -1.91652 -12.9082 +59 2 15.5551 16.5364 10.8674 2.44262 -0.34105 -1.56006 +60 2 16.2254 16.2298 9.51738 1.66683 0.349555 15.5208 +61 1 1.97926 4.78245 0.194184 -7.72676 6.8376 3.32149 +62 2 2.28164 5.2243 0.992573 8.53964 -6.59001 3.21257 +63 2 1.76914 5.52567 18.27 -2.63275 2.53007 -9.16672 +64 1 11.4134 13.2491 16.3873 0.68902 5.27402 2.7566 +65 2 10.9787 12.3908 16.4988 0.445492 6.36744 -3.52589 +66 2 11.9797 13.161 15.6117 0.593117 -3.37138 0.847423 +67 1 10.1151 10.9818 16.8138 12.4788 0.931853 3.10073 +68 2 10.558 10.1255 16.7937 -4.12284 -0.882862 -0.541555 +69 2 9.18349 10.8105 16.7424 -13.6774 -3.43657 -1.9902 +70 1 11.7994 17.4667 13.4795 12.7765 -4.5476 -2.07039 +71 2 12.3346 16.8373 12.9682 -4.67996 5.77396 2.18605 +72 2 12.2169 18.3179 13.2967 -7.11407 5.85224 3.16387 +73 1 6.41771 9.40938 12.2612 -1.11473 -8.0868 -15.4525 +74 2 7.03744 9.07449 11.5759 -13.2083 9.2101 17.4474 +75 2 6.9295 9.8935 12.9066 11.874 3.71682 2.38348 +76 1 16.2958 12.8923 2.71536 -7.68956 9.05075 5.11912 +77 2 17.1057 13.405 2.60095 0.726983 -7.0699 -1.53932 +78 2 15.5966 13.5689 2.77432 5.93986 -8.84533 -0.161974 +79 1 0.748159 12.7086 5.88144 -10.9756 -4.32923 1.80334 +80 2 1.126 12.5118 5.01571 -4.75041 4.90571 -2.30818 +81 2 18.4243 12.6438 5.75836 11.281 1.67442 1.09101 +82 1 5.27578 16.4085 18.412 4.21131 -11.5608 4.53747 +83 2 5.56823 15.5611 18.0525 -2.79743 5.31701 -3.02359 +84 2 5.61546 16.4141 0.666595 -0.372752 7.00853 0.303479 +85 1 0.645783 7.7249 4.17395 -22.5174 -18.1833 12.2453 +86 2 0.0406635 8.03244 3.50183 -6.8254 3.26088 -7.40309 +87 2 1.47404 8.07846 3.91568 30.354 9.58108 -9.75695 +88 1 3.15689 8.99663 6.46784 -29.6014 22.5811 -11.1032 +89 2 3.73467 8.6187 7.10087 15.4493 -13.4368 20.8179 +90 2 2.24881 8.95158 6.82736 13.2955 -4.68481 -5.71698 +91 1 7.31562 10.4015 16.2316 3.59442 1.76188 5.73087 +92 2 6.55849 10.6763 15.7162 -1.33577 1.2968 -0.922241 +93 2 7.0153 10.388 17.1537 0.717273 -3.98644 -9.35278 +94 1 11.0545 0.930228 4.99952 5.57476 -3.06583 5.10436 +95 2 11.2493 1.80197 4.63341 -8.70362 -0.159614 -5.22362 +96 2 10.8601 0.352804 4.24475 -0.891787 5.80331 3.4075 +97 1 4.31226 2.88036 13.174 -5.147 13.5187 -3.07305 +98 2 4.38813 3.36721 14.0053 4.89736 -4.04185 -0.502489 +99 2 4.16611 1.96327 13.4122 -1.31506 -9.67947 3.52696 +100 1 8.44169 10.2311 1.79631 7.56357 -11.9838 -1.9735 +101 2 8.31668 10.8926 2.47474 -4.45102 7.488 6.50539 +102 2 8.68604 9.43265 2.286 -2.4935 0.872154 -3.30188 +103 1 10.3613 1.71229 15.5051 2.98347 -4.15867 -5.41234 +104 2 11.2858 1.47948 15.6006 4.17674 0.252173 3.54686 +105 2 10.224 1.77346 14.5485 -4.83776 4.02156 4.39256 +106 1 2.62824 12.9587 7.89058 0.896502 -11.3927 -2.22701 +107 2 3.24219 13.4607 7.34422 -0.123332 4.88452 0.659902 +108 2 1.95928 12.6032 7.2874 1.64097 5.4786 -0.796639 +109 1 3.80872 11.636 4.95037 -11.7682 3.18495 22.2339 +110 2 3.64598 10.9456 5.61445 0.836076 6.10931 -6.44063 +111 2 2.95096 11.8687 4.56439 8.15456 -6.07271 -3.548 +112 1 6.68955 14.4669 16.969 -3.81156 3.78561 -6.36768 +113 2 7.31157 15.1356 17.2607 6.01474 -1.04117 -0.64393 +114 2 6.3928 14.7335 16.0851 0.840242 -1.58899 4.15547 +115 1 14.2051 14.5083 3.2908 -7.03725 6.3674 -0.58292 +116 2 13.7783 15.3639 3.15563 1.95336 -1.87129 -0.261548 +117 2 13.7683 14.1355 4.06228 2.52608 -4.66484 0.961916 +118 1 8.56009 18.0702 16.0712 3.20396 -8.67406 4.91505 +119 2 9.14753 17.3445 16.2475 -6.34669 -24.466 3.58587 +120 2 9.1857 0.126611 16.1642 1.87484 33.3672 -8.78222 +121 1 4.70115 1.72624 4.89274 27.4793 -6.96303 -5.48355 +122 2 3.95894 2.26041 5.13304 -17.2548 11.1403 -0.356707 +123 2 5.27782 2.26423 4.3214 -9.62564 -3.87491 4.20048 +124 1 15.0192 12.5587 16.5123 21.7041 14.8698 31.7439 +125 2 14.5985 12.983 17.2917 0.468388 -8.58398 -21.4185 +126 2 14.4797 12.5149 15.7347 -25.1252 4.80555 -9.98379 +127 1 15.7034 18.4851 16.8595 11.2428 14.4774 5.40242 +128 2 16.3726 18.3616 17.5507 -1.30019 6.81093 -3.04699 +129 2 15.2229 17.666 16.8625 -3.30988 -17.6635 -4.60623 +130 1 1.33118 1.27529 16.6047 -9.4861 0.393225 2.74141 +131 2 2.17004 1.71925 16.7831 -4.45817 3.09534 0.768406 +132 2 0.687638 1.66877 17.2201 8.28198 -2.79213 -3.95818 +133 1 18.1871 4.40384 15.9188 -4.2246 -5.6904 -13.4727 +134 2 18.0103 3.84369 15.1415 2.73285 7.2293 11.0268 +135 2 0.486098 4.58175 15.924 0.765927 0.250404 0.0527718 +136 1 12.1931 17.0307 16.1573 -7.03075 -8.39993 15.6705 +137 2 11.4402 16.4961 16.4862 10.3932 12.5123 -4.95214 +138 2 12.1197 17.0939 15.2076 -10.1529 0.179256 -12.7611 +139 1 16.106 2.59107 18.2096 -1.1157 3.6739 1.58184 +140 2 15.8464 3.51014 18.3379 -6.23469 -2.00336 3.76026 +141 2 15.8431 2.36085 17.3192 0.233798 0.882779 -7.24243 +142 1 6.71273 13.8002 10.1277 -4.97427 -8.24119 9.58999 +143 2 6.56779 13.4217 11.0085 1.93353 6.26249 -2.22943 +144 2 6.54815 13.0587 9.53715 2.49444 0.869035 -6.59786 +145 1 10.1873 18.4315 2.70955 18.3562 4.9239 2.5593 +146 2 10.5434 0.318979 1.97838 -6.6136 -2.73616 6.22508 +147 2 9.38189 18.0459 2.39836 -17.7025 -5.54205 -6.95436 +148 1 3.04496 17.7072 6.14474 -26.0897 -13.5421 -17.7616 +149 2 2.15406 17.5302 5.73662 26.1077 6.8467 16.2169 +150 2 3.64192 17.5514 5.40101 1.03601 7.77362 4.67988 +151 1 12.6273 16.8318 7.93854 -11.3452 0.662957 5.12661 +152 2 11.8845 16.2201 7.89678 1.40738 -6.80959 -10.3945 +153 2 12.3926 17.3902 8.68441 7.00662 7.84172 2.34647 +154 1 14.8855 15.2416 8.18261 -13.4645 13.8861 12.0711 +155 2 14.0556 15.7424 8.32689 13.5062 -6.9847 -4.51651 +156 2 15.2561 15.6092 7.37576 4.4997 -5.95581 -2.20609 +157 1 17.7963 18.2323 0.313468 22.8316 -1.73762 -16.8861 +158 2 18.5551 17.7341 -0.0636659 -20.2187 -0.580139 11.9305 +159 2 18.2144 0.43747 0.484185 -10.4644 5.54896 5.21224 +160 1 0.772309 10.5133 1.37975 -10.1333 -30.1062 6.79594 +161 2 0.0813059 9.81759 1.5081 15.2254 18.695 2.54909 +162 2 0.385285 11.1613 0.797203 -0.976125 9.32481 -5.57513 +163 1 1.78018 12.2676 3.33949 2.15539 9.4235 -7.57379 +164 2 1.54035 11.6193 2.6706 -4.1225 -6.27654 2.3776 +165 2 2.05243 13.0385 2.81809 -2.70385 -1.96831 6.56166 +166 1 0.659925 17.2426 4.96586 -18.1386 9.04401 18.0738 +167 2 0.178596 18.0473 5.21064 6.21229 2.02654 -16.1731 +168 2 0.324647 16.6226 5.62628 12.0605 -8.44774 -8.6881 +169 1 1.10032 0.835558 9.36207 -6.74911 6.08386 15.0138 +170 2 1.34007 0.666464 10.2949 -2.02307 -2.81345 -10.1719 +171 2 0.1714 0.592543 9.31025 -1.22709 -3.40717 -2.54195 +172 1 16.7505 2.35163 13.3289 8.60057 15.8485 -12.5846 +173 2 16.88 2.58008 12.3859 -1.48994 0.98841 16.7513 +174 2 16.5792 1.4154 13.3346 -5.94985 -15.1034 2.43107 +175 1 2.68711 15.9094 12.0537 -2.04437 -0.129745 31.1177 +176 2 3.02052 15.4906 12.8711 -6.40464 9.26827 -14.3072 +177 2 3.17282 15.5129 11.3342 0.535683 -2.02659 -8.3952 +178 1 16.4208 15.6182 6.1352 -21.1289 -3.6799 -9.5135 +179 2 17.2955 15.5836 6.51556 8.3115 3.57969 -3.1518 +180 2 16.3537 16.3493 5.49765 5.76519 -7.13598 7.22522 +181 1 5.79664 5.13529 11.8088 -4.38676 10.3557 2.90642 +182 2 5.60006 6.00552 12.2032 -0.739769 -8.67447 -3.0914 +183 2 5.02307 4.59055 11.9941 4.66701 -2.35447 -0.0408817 +184 1 15.1607 4.87263 0.806669 16.5091 -1.57376 7.82361 +185 2 14.8955 4.71033 1.72542 2.63671 -2.24198 -6.9535 +186 2 14.4069 5.23734 0.370441 -15.2288 7.71764 -6.62645 +187 1 16.3977 16.3968 1.96949 3.68196 12.8197 -24.7966 +188 2 15.8359 16.7471 2.65913 3.23547 3.93446 11.4731 +189 2 16.7724 17.1777 1.4991 -6.44753 -16.1278 10.1249 +190 1 0.213933 4.82135 3.88253 -26.808 7.93653 -12.3623 +191 2 0.234051 5.77519 3.99531 2.75938 5.29795 -1.25016 +192 2 0.961943 4.50047 4.34745 23.7428 -13.1307 13.4767 +193 1 2.96019 15.0595 15.1256 -5.74802 5.98414 7.79678 +194 2 2.74143 14.6748 15.982 5.94976 -7.2483 0.528018 +195 2 2.64636 15.9627 15.2549 -2.4967 2.40481 -11.2251 +196 1 1.11613 14.6445 9.47707 24.3082 -3.71628 -27.1602 +197 2 1.83443 14.0608 9.11052 -24.4018 17.7336 11.9542 +198 2 0.662892 14.1245 10.1216 -3.75634 -10.5151 15.6601 +199 1 13.5123 16.5361 11.5209 14.3415 8.92342 18.194 +200 2 13.0624 17.3115 11.1648 -0.833334 -0.722864 -7.66511 +201 2 12.9752 15.7809 11.2867 -3.03575 -6.70349 -11.2125 +202 1 4.68996 1.46706 0.718872 11.9134 2.33738 12.4928 +203 2 4.09477 2.04355 0.241198 -5.36661 3.4607 -5.79099 +204 2 4.1604 0.969338 1.36347 2.85434 0.638429 -14.0321 +205 1 1.49954 18.563 11.8891 -5.50653 18.8512 6.56283 +206 2 1.44134 0.571379 12.6129 -0.0136494 -9.64138 -5.67935 +207 2 2.21117 17.97 12.1221 3.30859 -8.66659 1.78907 +208 1 11.4402 10.1273 4.0296 -14.1313 -2.26429 -1.73879 +209 2 11.5467 10.5306 3.16018 -4.20959 -0.177974 3.37558 +210 2 12.3237 10.0244 4.36159 16.2917 -0.468181 5.60308 +211 1 8.19952 12.1987 3.67367 7.5254 -0.929385 2.30686 +212 2 9.06593 12.5735 3.89529 -5.56433 -0.233543 6.4332 +213 2 7.60827 12.3201 4.43288 5.90715 0.804339 0.890554 +214 1 14.5695 4.00736 3.30806 -0.853883 -3.91237 -3.28064 +215 2 15.2428 4.12216 3.97778 4.83301 -0.192226 6.11595 +216 2 13.7947 4.43075 3.66998 -10.7695 5.18811 0.448659 +217 1 5.68852 1.65707 7.54168 28.123 23.6896 24.0894 +218 2 4.98915 1.23464 8.0079 -23.0977 -17.1785 12.6492 +219 2 5.54722 1.47278 6.63267 -9.12733 -3.0122 -32.3212 +220 1 17.8871 1.01837 4.84182 2.82015 7.71075 0.411156 +221 2 18.4334 1.54735 4.24341 -1.55475 -9.21419 -1.50179 +222 2 17.685 1.60385 5.57556 -2.0638 -1.04483 2.6292 +223 1 6.8166 9.34907 4.51783 5.09473 -9.82493 1.7662 +224 2 6.68916 9.48214 5.46541 0.845655 -0.0829088 -1.52267 +225 2 7.72677 9.02302 4.42297 -5.47106 2.64724 -1.23342 +226 1 2.52902 14.8001 2.0243 -5.93162 -1.84873 -28.2955 +227 2 3.33024 14.7833 2.53171 11.9325 -2.28831 13.4023 +228 2 2.81062 14.7362 1.08886 -6.14041 -0.158095 16.8135 +229 1 17.2862 12.9192 13.1313 -13.4327 18.0081 -1.69868 +230 2 16.3974 13.2513 13.3936 19.5241 -4.39437 -6.93828 +231 2 17.8009 13.724 12.9107 -8.95295 -13.2998 3.51907 +232 1 14.8818 10.557 1.42323 -17.5015 7.25829 9.68839 +233 2 15.2835 11.3752 1.77244 -3.15433 -10.3089 -2.91904 +234 2 13.933 10.5609 1.67153 21.0133 3.93252 -5.34474 +235 1 5.70173 6.62264 4.58284 3.01718 2.50499 1.71703 +236 2 5.75902 7.56019 4.39794 2.55817 9.91828 -0.0203224 +237 2 6.42399 6.43452 5.20085 -6.85011 -4.70646 -2.52597 +238 1 8.0341 8.36204 10.3892 10.4405 -6.77488 -14.8808 +239 2 8.6296 8.90948 9.85447 -2.74542 2.30932 7.48232 +240 2 7.64772 7.74454 9.75603 -3.95063 2.60786 3.00172 +241 1 13.4272 18.4528 5.67238 9.25795 -5.11499 9.49722 +242 2 12.7163 0.440246 5.56173 -10.019 1.98309 -6.96611 +243 2 13.1619 17.9514 6.45613 2.7128 -4.57063 -2.8 +244 1 -0.0270522 2.62208 0.316378 14.2494 -14.2567 4.73545 +245 2 17.7181 2.78355 18.7164 -19.3625 -8.86024 -5.69671 +246 2 0.361548 3.46719 0.160861 21.2807 17.6319 0.792983 +247 1 12.9304 10.9756 9.73287 -28.9199 -18.5822 3.85047 +248 2 11.9453 10.9259 9.78333 22.7984 8.3459 -7.73181 +249 2 13.1639 10.0723 9.99967 2.00349 4.19966 -2.07729 +250 1 0.632704 12.1509 11.1096 7.92792 10.2243 1.08862 +251 2 18.3238 12.1837 11.2671 1.30826 1.36738 8.17016 +252 2 1.12128 12.4175 11.9061 -11.5401 0.628467 -1.63311 +253 1 5.16172 7.34292 13.3779 5.89076 -0.786387 1.26512 +254 2 5.63913 8.13751 13.0818 -0.253704 -8.62988 -1.18816 +255 2 5.64992 7.00871 14.1461 -2.49218 7.71701 -3.25354 +256 1 1.18315 6.80996 11.9457 -21.1971 9.90527 -11.1777 +257 2 0.396163 7.2181 11.5121 19.4256 -12.5543 10.5539 +258 2 1.74685 7.55572 12.1675 3.51989 2.12142 1.71712 +259 1 15.5171 9.71047 12.3281 2.29457 -6.5479 -4.23973 +260 2 15.3017 10.6102 12.0519 -2.15799 -4.39765 10.01 +261 2 15.6816 9.70968 13.2745 -0.591496 3.33032 -0.321137 +262 1 16.5873 12.6729 5.56721 2.76163 -0.166181 -5.31991 +263 2 16.3773 13.5773 5.84608 0.225425 -0.965456 -7.72797 +264 2 16.4542 12.6253 4.60029 -0.729256 4.09093 10.083 +265 1 6.36605 9.79142 0.024922 -16.0501 18.8211 -0.426432 +266 2 5.53971 10.2677 0.213525 8.17613 -4.10964 1.60097 +267 2 6.98218 10.0336 0.714657 7.30358 2.91784 7.9977 +268 1 12.2857 6.09281 4.02237 -18.7873 -18.2554 10.8389 +269 2 12.2499 6.90248 3.51498 -0.180994 1.77121 -11.4426 +270 2 11.3769 5.71462 3.99073 18.6718 6.8659 -0.0124277 +271 1 0.371339 12.8581 0.116813 -11.2914 -0.881026 -5.3546 +272 2 18.6979 13.4634 0.798717 1.88955 0.580482 0.906428 +273 2 18.4407 13.0157 17.9982 0.051521 1.66817 1.81741 +274 1 3.57562 18.6672 8.63597 16.8652 -4.29809 -8.00937 +275 2 3.39672 18.3023 7.75382 0.438355 1.17547 6.33464 +276 2 2.72388 0.290377 8.97499 -6.05452 1.31479 -1.62581 +277 1 7.38199 17.3678 4.46374 -1.38292 15.3105 6.33947 +278 2 7.69148 18.255 4.75287 -6.89683 -17.7129 -9.79531 +279 2 7.51455 17.3077 3.50947 0.595015 4.11355 1.7546 +280 1 9.26329 17.1448 12.185 -8.64248 6.96454 5.63337 +281 2 9.31183 16.2501 11.845 1.80177 -5.78684 -3.53436 +282 2 9.93599 17.2354 12.8685 5.43729 -1.39148 -3.55242 +283 1 13.2821 13.1028 8.02698 11.8692 -15.3168 6.16039 +284 2 13.4688 12.3189 8.5813 -8.97739 12.1367 -7.14337 +285 2 14.105 13.618 8.04076 -8.38267 2.98351 0.0644509 +286 1 14.8025 2.98142 15.4294 17.4288 1.80056 -2.61073 +287 2 14.201 2.26032 15.2834 -13.2348 -7.60023 -2.35086 +288 2 15.3302 3.01554 14.6169 0.118996 0.402428 5.45631 +289 1 9.92493 15.6251 16.9821 6.00495 -5.53666 -0.13681 +290 2 10.4191 14.8506 16.6821 -3.27256 -3.64184 -5.012 +291 2 9.59076 15.3546 17.8439 -3.58917 5.2502 2.724 +292 1 11.2797 8.49868 16.6198 -1.73472 -6.52809 -3.79184 +293 2 10.75 7.88393 16.0952 -2.42874 5.03231 0.808132 +294 2 11.4092 8.05007 17.4587 2.82097 -1.86681 0.519814 +295 1 4.04678 18.2455 16.7988 -8.77416 25.1666 -6.65304 +296 2 4.65779 17.694 17.284 2.06605 -2.99109 10.2548 +297 2 3.96053 0.454509 17.276 5.60906 -19.8799 -5.16878 +298 1 2.27095 4.25175 8.91936 5.9784 -6.58712 9.82608 +299 2 3.2186 4.2524 8.72216 -4.79336 -1.38402 1.94738 +300 2 2.18112 3.96584 9.85003 1.09756 8.39619 -11.3917 +301 1 9.88624 10.3936 9.78011 6.22166 -2.86793 -13.7384 +302 2 9.62293 11.2772 9.51568 -5.75811 3.67729 -6.27375 +303 2 10.0642 10.4241 10.7104 0.548842 -0.969577 22.0405 +304 1 9.71663 0.937962 10.8586 -0.709221 -7.70358 -11.4846 +305 2 9.30987 0.134657 11.1937 5.18354 -4.14977 6.17978 +306 2 9.11908 1.1943 10.1452 4.37988 8.3302 1.85952 +307 1 9.18198 15.0956 10.1953 -4.26962 6.22766 7.58802 +308 2 8.89777 15.9846 9.95951 0.743088 2.4445 -7.53567 +309 2 8.34997 14.6032 10.2066 5.52748 -3.88041 -1.79992 +310 1 0.872205 9.70338 10.2435 26.5305 -15.7209 -40.6294 +311 2 0.885793 10.5746 10.6186 -2.04601 10.7115 5.01116 +312 2 1.5471 9.74995 9.50099 -28.1395 -6.59839 33.8889 +313 1 17.1072 4.85649 8.10795 10.9462 -15.5033 5.93553 +314 2 16.3968 5.45295 8.31142 -11.4282 10.1371 2.96807 +315 2 17.1775 4.27052 8.87929 1.82351 6.10377 -11.9311 +316 1 14.794 14.6968 0.0807509 -15.0506 -16.2211 -7.1198 +317 2 15.1293 15.3316 0.707575 7.57499 5.98458 11.2724 +318 2 13.942 14.3729 0.412504 5.92115 1.12787 4.02247 +319 1 3.8058 11.0463 9.54758 -4.72716 5.89465 -11.0149 +320 2 3.75265 11.4758 10.4012 1.08641 -1.46789 11.7249 +321 2 3.34125 11.6425 8.94232 1.4747 0.62014 0.836248 +322 1 11.3036 10.7395 1.51518 17.421 7.70001 -9.9965 +323 2 11.5572 11.5513 1.04939 0.916953 -2.49636 4.28379 +324 2 10.3663 10.6689 1.38091 -17.6315 -2.91035 -1.9437 +325 1 13.1498 7.19173 12.6392 -12.6781 -12.1868 5.62798 +326 2 14.0645 6.9093 12.7169 6.63809 2.55694 -2.55252 +327 2 12.6264 6.38473 12.8035 6.43409 8.48166 -2.8301 +328 1 9.6244 1.91603 0.948782 1.73007 4.87205 -17.2591 +329 2 8.78103 1.84907 0.47922 2.387 -4.26061 4.8929 +330 2 10.2561 2.20979 0.275304 -2.56753 1.91417 5.98087 +331 1 10.6541 13.4625 4.53479 -4.64228 5.78216 2.02785 +332 2 11.5543 13.1406 4.67483 -3.60366 -2.8444 3.58336 +333 2 10.4931 14.1115 5.23949 3.28752 -7.90473 -1.94244 +334 1 14.4847 1.66582 10.9548 -5.6847 9.24739 -2.41061 +335 2 15.2495 1.25185 10.5509 3.51804 0.734089 -1.48015 +336 2 14.6665 2.62215 10.9157 -2.44239 -9.64589 2.94827 +337 1 14.5153 12.0551 11.6598 -8.57838 4.331 1.02894 +338 2 15.2406 12.4341 11.1775 15.6624 8.75252 -5.54666 +339 2 13.8905 11.8145 10.9694 -5.00706 -1.53612 2.9308 +340 1 8.18805 5.09916 9.82303 -13.8101 6.02591 4.86356 +341 2 7.31243 5.14562 10.2589 14.5937 -0.354252 -5.27398 +342 2 8.2462 4.20505 9.47267 -0.0530366 -3.80538 1.315 +343 1 1.47125 16.9173 18.4665 17.3664 16.657 -21.1079 +344 2 1.9236 17.2269 17.6455 -9.65792 -6.20403 18.6505 +345 2 1.59593 15.9726 18.4726 0.464255 -9.97504 -1.82966 +346 1 1.48039 17.3287 15.3228 1.51401 14.0556 6.72393 +347 2 1.34693 18.2292 15.6575 8.56134 -5.76509 -0.66881 +348 2 0.596093 16.984 15.2507 -11.2139 -7.77617 -1.25224 +349 1 3.58273 5.77174 6.05172 -7.98503 -18.1926 7.56457 +350 2 3.04578 6.35459 6.60151 3.24577 3.33226 -0.333817 +351 2 4.18271 6.30655 5.53303 2.15541 4.89174 -3.71227 +352 1 12.4965 9.48476 14.2165 -0.670713 16.0192 -6.73881 +353 2 12.9556 8.76438 13.7775 2.07937 -6.9932 3.10842 +354 2 12.3436 9.22115 15.1264 1.05397 -7.72063 3.19376 +355 1 4.0654 15.2599 7.01126 14.536 -9.99762 3.77636 +356 2 3.57418 16.0458 6.77165 -4.77502 7.81332 -2.1228 +357 2 5.00035 15.4681 6.83264 -6.89866 -1.23873 3.67355 +358 1 0.723833 8.69198 15.0851 1.39297 0.947643 -5.33928 +359 2 0.438801 9.60781 15.1421 -2.06214 4.43911 1.45744 +360 2 1.38458 8.70272 14.3802 0.858615 -3.42768 2.38717 +361 1 12.8756 8.29184 10.1606 18.5084 -5.85873 3.08502 +362 2 13.7209 7.89345 9.85142 -16.8549 4.13316 8.30657 +363 2 12.7515 7.97965 11.0724 6.23426 1.04322 -7.42686 +364 1 15.3229 7.8277 3.50947 17.5558 22.7432 -34.5468 +365 2 14.4697 7.71438 3.07339 -7.31906 -8.87793 15.8657 +366 2 15.4806 7.65388 4.43399 -18.8005 -15.0751 11.2523 +367 1 17.2596 6.73529 0.0260639 -2.34928 8.60384 0.474092 +368 2 16.7705 6.01921 0.434638 -6.55856 -4.92879 -0.567585 +369 2 16.5991 7.41683 18.4475 3.41319 -8.53114 -0.808778 +370 1 8.95463 6.95692 7.78734 -12.7059 -4.64784 9.91199 +371 2 9.87027 7.23168 7.81087 8.51327 4.71948 -0.0600656 +372 2 8.83651 6.35153 8.53608 0.68522 0.961995 -1.89804 +373 1 12.4059 0.607414 1.26231 3.62116 2.02707 -9.0712 +374 2 13.2571 1.01103 1.48145 3.02509 -6.80244 -1.55076 +375 2 12.4394 0.42011 0.312768 1.30302 -0.072107 7.45087 +376 1 5.61221 15.1181 14.5069 21.81 1.56396 -5.03583 +377 2 4.69671 15.2613 14.7447 -7.9418 2.21424 1.99916 +378 2 6.02853 15.9808 14.3125 -8.14435 -8.16553 0.0834836 +379 1 3.81616 6.42663 1.71897 -4.74342 3.6354 -4.79161 +380 2 3.34042 7.16969 1.31421 3.65203 2.80462 3.7212 +381 2 3.89499 6.64183 2.65143 -2.11765 2.44111 2.19083 +382 1 3.90516 11.4598 12.3793 9.45586 -8.94044 -12.3546 +383 2 4.79548 11.8227 12.4942 -7.15738 -0.735807 -0.876075 +384 2 3.31554 12.0782 12.7961 -9.4854 7.67777 7.65311 +385 1 5.30665 3.87758 15.8091 -6.5654 14.2288 -0.0449474 +386 2 5.99806 3.22942 15.6938 11.0923 -7.17561 -6.6845 +387 2 5.74209 4.7421 15.8325 -0.91092 -4.98763 -0.535492 +388 1 14.1952 10.2038 4.61463 -6.5923 1.74463 -22.8561 +389 2 14.2343 9.86507 5.49824 4.23866 -7.49318 19.2708 +390 2 14.5963 9.53108 4.04607 2.17028 4.66107 2.75401 +391 1 7.63145 17.3499 9.0679 -5.43123 5.71002 -0.0698024 +392 2 6.89643 17.6949 9.58041 -2.21022 -5.88459 7.45639 +393 2 7.83827 18.0718 8.46746 8.40651 -1.69566 -7.5742 +394 1 4.52514 14.4769 3.85867 5.05038 7.53463 5.39007 +395 2 4.64261 15.388 4.18066 -3.91408 -9.29834 -6.31781 +396 2 4.46355 13.9264 4.6465 1.7827 -2.93555 -2.6265 +397 1 14.2493 7.38723 15.8586 4.87219 -5.15553 -0.709446 +398 2 15.1473 7.29965 15.5014 -5.21416 1.68161 3.76194 +399 2 14.3665 7.7773 16.7353 0.544226 -0.39761 -4.2243 +400 1 3.0581 18.4144 1.95119 -22.1859 -8.41359 7.65322 +401 2 2.57832 17.7386 1.43356 3.30075 12.2585 2.4632 +402 2 2.38613 0.281938 2.45339 8.18993 -10.3808 -10.0068 +403 1 7.97435 1.63455 4.58282 23.9975 -9.20271 -17.826 +404 2 7.40194 1.94347 3.87976 -9.32013 4.13397 -1.27928 +405 2 8.80392 1.4125 4.10448 -12.4762 5.5818 15.8983 +406 1 2.4378 14.1623 17.6894 -3.94912 5.20331 -2.53114 +407 2 1.6661 13.615 17.8755 3.58117 1.8004 4.78536 +408 2 3.18519 13.6404 17.9779 13.28 -5.73443 1.82606 +409 1 0.901685 1.86492 13.8925 12.6905 0.691236 2.76957 +410 2 0.97461 1.67681 14.8348 2.02403 -0.73996 0.457614 +411 2 -0.0244921 1.99897 13.7259 -14.1961 2.08272 -4.4518 +412 1 4.37872 0.0904002 13.8777 13.1739 1.11326 -7.50903 +413 2 5.30332 18.4699 13.7308 -6.52685 1.52196 1.48666 +414 2 4.22979 18.5754 14.8098 -5.10379 -2.3914 9.04502 +415 1 7.27651 0.845893 18.3957 -16.6762 17.2151 26.568 +416 2 7.1678 0.492927 17.521 -0.448362 -6.22938 -12.6047 +417 2 6.39207 1.1517 18.718 17.8505 -10.612 -11.3067 +418 1 15.9607 18.375 13.9642 -35.6371 5.35013 -16.5011 +419 2 15.0008 18.4642 13.7578 26.2499 -2.51915 -0.30366 +420 2 16.0214 0.00880953 14.871 6.50934 -2.46523 19.0717 +421 1 10.2176 4.60873 16.2514 5.45645 -16.296 -9.2455 +422 2 11.1834 4.4434 16.3559 -20.4013 6.80033 -5.0518 +423 2 9.84346 3.80184 15.8357 11.7075 10.859 12.3241 +424 1 15.9288 17.6854 4.49702 -25.8895 1.84686 -2.2825 +425 2 16.5611 18.3979 4.49336 8.57016 10.0602 -1.14853 +426 2 15.0697 18.092 4.72548 12.7214 -6.58434 0.45321 +427 1 6.97646 17.4765 13.8835 1.51347 6.32825 6.74987 +428 2 7.46829 17.7625 14.676 -2.92413 -3.08896 -9.25103 +429 2 7.63479 17.4162 13.1781 -0.793447 -1.23312 2.0982 +430 1 13.2369 6.46193 6.55272 7.97686 -7.07829 -14.9633 +431 2 14.2045 6.47863 6.50403 -7.11621 7.88379 2.07663 +432 2 12.9571 6.40302 5.61769 -2.27464 -2.27743 14.9713 +433 1 7.84752 2.28013 9.41028 -8.73892 -0.731414 -17.5278 +434 2 7.29261 2.26329 10.1936 -2.39479 -1.12016 7.77392 +435 2 7.27021 1.99883 8.67538 7.42107 2.89864 6.55304 +436 1 15.163 14.8378 13.7075 -5.08255 6.9114 -1.94911 +437 2 14.828 14.9803 14.5966 0.517852 0.790599 5.03408 +438 2 14.8205 15.5736 13.1818 1.46712 -6.90646 -0.613497 +439 1 9.40195 8.33905 3.81803 -16.6236 -1.1153 -3.723 +440 2 10.1861 8.88666 3.81624 11.7714 1.21262 5.85608 +441 2 9.65895 7.42947 4.01423 -0.646232 2.08147 -2.76231 +442 1 17.7496 13.6056 16.4496 1.61536 7.2683 -6.30775 +443 2 16.7925 13.5164 16.4445 -3.33508 -5.74033 1.31806 +444 2 17.9176 14.3949 15.9026 -1.24178 -7.25826 8.29135 +445 1 4.89231 10.51 2.8606 23.2586 -26.6571 -20.5821 +446 2 5.63741 10.0083 3.24852 -7.78968 12.4235 -4.83768 +447 2 4.54582 11.03 3.56787 -4.03679 11.8248 12.8852 +448 1 3.69823 8.4002 10.0127 -3.60192 -11.2793 13.5005 +449 2 3.83759 9.3113 9.76164 0.279778 8.83932 -1.11316 +450 2 3.64192 8.42085 10.9836 -1.53751 -1.28356 -9.75822 +451 1 15.9467 6.92332 5.94112 11.8737 -8.24502 3.37919 +452 2 16.7476 7.39494 6.19571 -0.497479 1.69122 3.51528 +453 2 16.2467 6.02535 5.70675 -5.68891 13.7396 -0.851978 +454 1 15.1658 7.18492 9.0507 -10.4703 -15.8706 0.47552 +455 2 15.9236 7.59272 9.46168 11.862 8.93317 3.67812 +456 2 14.9906 7.60382 8.20629 4.02444 8.70872 -4.23998 +457 1 6.21618 12.8841 12.7284 -3.21766 12.2709 11.5322 +458 2 6.77909 12.207 13.0973 14.7659 -5.65099 1.01901 +459 2 6.15827 13.5741 13.4151 -3.2657 -3.93324 -9.28774 +460 1 12.1165 4.51288 13.1048 -1.62418 -0.0716723 20.7898 +461 2 12.3817 4.58382 14.0419 2.18295 3.85449 -11.1604 +462 2 11.2475 4.10019 13.1569 -0.321339 -3.45694 -9.73345 +463 1 11.4166 8.11249 7.92599 8.37678 -3.86112 -10.8327 +464 2 12.0468 7.60844 7.37796 -5.38848 4.21425 7.2331 +465 2 11.8428 8.18692 8.79136 -5.59584 -0.0130509 -4.24997 +466 1 17.091 10.8655 7.57222 -5.5019 -10.6926 10.9756 +467 2 17.8562 10.3128 7.37833 -2.02493 -0.998523 -7.2616 +468 2 16.8515 11.3839 6.80089 6.08197 4.8342 -8.48749 +469 1 5.2937 18.1227 10.8823 3.58086 -4.72457 -4.80722 +470 2 4.89277 17.7527 11.67 -2.28546 -3.10604 1.32943 +471 2 4.67512 17.9479 10.167 -5.31481 4.288 -3.34371 +472 1 7.59808 17.4966 1.71058 0.398559 1.64094 13.9409 +473 2 7.8828 16.705 1.25288 5.11743 -4.18927 -7.63945 +474 2 7.62118 18.2252 1.08608 -3.03358 1.0728 -8.8916 +475 1 1.91712 12.8862 13.5909 8.98798 9.32187 -3.03347 +476 2 1.48166 12.3531 14.2581 -2.09819 -2.06604 3.51643 +477 2 2.30811 13.6552 14.041 -7.16378 -5.11315 -1.13098 +478 1 9.42828 6.75322 14.7826 20.1915 -11.5504 -11.1057 +479 2 9.8277 5.94835 15.1588 -6.88663 6.02054 3.69259 +480 2 9.80073 6.79406 13.8821 -8.1098 8.28496 9.35183 +481 1 15.2968 4.25709 10.7854 2.83104 8.23395 -4.89519 +482 2 16.2313 4.08269 10.6128 -5.94582 -2.20316 7.08238 +483 2 15.3124 5.02999 11.3646 -3.5924 -3.42311 1.83328 +484 1 11.2927 6.22318 0.123361 12.5475 12.622 0.859144 +485 2 11.5233 5.29113 18.7512 -7.74436 -5.44097 -5.24926 +486 2 10.3808 6.34995 18.4806 -0.327163 -9.85792 5.03233 +487 1 18.5472 11.423 14.9732 18.3726 -20.3084 16.0571 +488 2 18.105 11.7915 14.2257 -13.2839 12.4126 -20.1368 +489 2 18.4564 12.0929 15.6514 -4.79118 8.10765 5.85542 +490 1 7.00881 9.27577 7.32015 -11.3868 -9.38104 -0.512081 +491 2 6.68278 8.41602 7.64312 1.53223 10.0212 -0.264373 +492 2 7.94615 9.16913 7.19167 13.4366 -2.83724 0.374421 +493 1 18.3388 15.3149 12.278 7.79295 4.11927 0.907342 +494 2 0.562248 15.7272 12.1255 -3.32497 -4.13752 -3.12696 +495 2 17.7171 15.7348 11.6722 2.18188 4.14775 -1.5511 +496 1 16.4968 4.40066 5.28798 -9.94208 -5.06851 -0.773295 +497 2 16.7853 4.2225 6.18546 2.9967 -3.39819 7.99443 +498 2 17.2662 4.33461 4.72457 15.1936 4.75592 -3.34352 +499 1 17.7173 3.18772 10.7866 10.4448 7.42964 -1.18609 +500 2 18.6422 3.37989 10.9855 -1.52891 3.674 4.44234 +501 2 17.7488 2.39891 10.2588 -4.04978 -15.6839 -7.32077 +502 1 12.3149 18.6145 10.0881 -2.22129 4.11252 3.54852 +503 2 11.4444 0.333084 10.2939 -3.02626 -1.86973 1.00626 +504 2 12.9201 0.705852 10.2372 4.71846 0.03299 -1.96706 +505 1 10.3684 9.76179 12.4758 17.9734 4.74974 2.50525 +506 2 11.1916 9.84607 12.9926 -11.8304 0.187235 -1.96375 +507 2 10.3012 8.81681 12.3218 -3.77483 -3.01576 0.0814472 +508 1 0.689392 2.74058 7.08104 -5.98449 10.1616 9.8561 +509 2 0.88859 3.44563 7.72485 0.581102 -9.26818 -8.93017 +510 2 0.974446 1.93578 7.5088 2.3916 -6.77547 7.05728 +511 1 0.277472 15.3259 6.84135 0.228059 -1.31559 -11.5462 +512 2 0.516029 15.5821 7.71821 6.50181 -1.47438 23.8891 +513 2 0.58839 14.4222 6.74639 0.679055 -1.95969 -5.2972 +514 1 17.0529 6.97528 15.0633 10.9144 -7.53558 1.72506 +515 2 17.8201 7.55974 14.9678 -6.11827 1.26888 -1.51964 +516 2 17.4266 6.16431 15.4413 -5.39729 2.11926 -0.659196 +517 1 9.11957 12.4732 8.03484 -32.1356 7.88594 4.6652 +518 2 9.41535 11.8783 7.35952 15.5672 -13.5118 -9.19924 +519 2 8.15954 12.512 7.86156 14.5216 4.72308 9.92056 +520 1 1.18275 1.7303 2.88012 3.13258 6.74516 -6.07855 +521 2 0.990874 2.23802 2.08159 -8.2151 -5.8717 0.0306137 +522 2 1.74436 2.31191 3.39299 4.34337 2.29394 9.11202 +523 1 4.11863 15.0886 9.98721 11.0177 -1.77256 -13.134 +524 2 4.02022 15.2012 9.03136 -3.58336 0.815549 3.23991 +525 2 5.04995 14.8741 10.1041 0.462863 -2.8957 0.615957 +526 1 7.38268 2.21023 14.7219 2.37064 11.9314 4.06902 +527 2 7.04717 1.62795 14.04 0.302375 -0.796384 -5.36483 +528 2 7.78873 2.97247 14.2654 -8.69617 -12.215 6.09363 +529 1 18.4343 14.5687 2.16054 8.35658 -0.618946 0.782777 +530 2 0.682906 14.919 2.34098 -12.2336 -1.59186 -0.620803 +531 2 17.7977 15.2902 2.22089 3.32879 4.73949 -0.959115 +532 1 10.0087 2.72001 12.9057 2.08485 -1.52945 -12.9938 +533 2 10.0412 2.17732 12.096 -1.38389 3.39971 12.264 +534 2 9.25575 3.30628 12.7713 -2.15732 -0.406341 3.704 +535 1 2.9831 8.88024 13.0189 0.952466 11.8173 -3.08609 +536 2 3.31938 9.77893 12.8076 -5.04245 -14.2298 4.61688 +537 2 3.71596 8.41411 13.4449 -4.1112 -0.429279 -5.2011 +538 1 3.20203 8.5912 3.76846 -11.4045 -12.6583 26.9753 +539 2 3.76961 9.22975 3.3591 6.50161 14.1888 -13.0281 +540 2 3.15464 8.85629 4.71231 4.40411 -9.17072 -19.7321 +541 1 5.64764 7.22249 8.60582 -2.45044 -0.628932 2.27153 +542 2 5.55364 6.27099 8.49955 3.15339 -1.29251 -2.67256 +543 2 4.90409 7.47651 9.17344 9.24373 2.45699 -1.73114 +544 1 14.907 1.53023 1.85078 -7.37767 -15.1485 8.29721 +545 2 14.668 2.24872 2.45072 11.5035 7.56218 -5.89301 +546 2 15.6059 1.77377 1.2289 -9.91057 9.46649 1.95684 +547 1 8.55561 15.0845 0.759561 -2.78586 4.97755 1.3099 +548 2 9.2232 15.1059 1.46635 -5.75771 -3.12613 -8.68727 +549 2 7.79979 14.5909 1.11068 3.03755 -1.08449 1.22088 +550 1 15.5064 1.39564 7.20176 -2.04619 -6.07348 -4.735 +551 2 14.846 0.870461 6.73047 4.3658 -0.949999 1.00211 +552 2 15.0733 2.23713 7.35024 -3.19526 7.79987 5.63196 +553 1 4.99693 12.9582 18.4618 -8.43591 -3.95032 12.7964 +554 2 5.427 12.9558 0.691187 -3.21166 1.68806 -6.66553 +555 2 5.5701 13.4759 17.8974 6.4766 -1.03013 -3.5001 +556 1 15.3823 8.61159 18.0651 4.42877 2.22092 -6.07372 +557 2 15.8154 9.23321 17.4587 -2.51695 -7.00562 1.90652 +558 2 15.1591 9.14089 0.186524 -1.03798 5.78876 7.10622 +559 1 12.0334 3.10844 18.3299 11.3082 -20.8993 7.10454 +560 2 12.3341 2.61645 0.471712 -7.66483 12.171 -5.21514 +561 2 12.3614 2.54753 17.6085 -4.58122 9.25845 0.807451 +562 1 13.192 12.7001 5.16537 5.21593 -6.7049 -2.26257 +563 2 13.6127 11.9331 4.74049 -3.39065 6.67562 5.25333 +564 2 13.2679 12.5364 6.11315 0.126366 6.17512 0.133491 +565 1 6.11282 7.21918 0.158665 1.88014 -14.5403 11.0752 +566 2 6.12514 8.17662 18.815 -2.86446 -0.617519 -0.818148 +567 2 5.41227 6.95692 0.781338 0.907384 -1.18964 -10.3034 +568 1 17.7111 15.8907 14.9544 -3.82577 1.28333 3.96962 +569 2 16.7386 15.9987 14.9233 18.3395 -0.0507343 -6.61585 +570 2 18.0408 15.7242 14.0577 -12.1828 1.42979 -0.226855 +571 1 13.1366 0.926204 16.6604 -4.9212 9.87611 -1.92759 +572 2 14.096 0.89187 16.7156 4.29984 -5.34206 5.94224 +573 2 12.8563 0.0335376 16.4436 -2.56348 -3.63873 3.02874 +574 1 10.9184 14.5253 7.38829 1.38398 -2.03118 7.00079 +575 2 10.1136 14.2278 7.85844 13.304 -1.52714 -8.95405 +576 2 11.6006 13.8396 7.51991 -9.17062 7.88742 -1.04716 +577 1 17.6363 8.46247 2.12178 -2.04395 4.31685 9.18728 +578 2 16.787 8.41765 2.58806 4.70486 1.56362 -5.63911 +579 2 17.6123 7.75928 1.47082 0.631216 -3.65047 -4.17578 +580 1 12.4375 7.79355 2.00637 -2.34281 23.5579 2.73553 +581 2 11.9501 8.63365 1.95534 8.51098 -6.49732 1.55884 +582 2 12.0343 7.24559 1.33225 -2.11395 -7.52965 -2.88654 +583 1 12.0451 14.5968 10.4885 2.58602 -10.5702 -25.2135 +584 2 12.3016 14.3716 9.56719 -0.183055 2.34539 21.1217 +585 2 11.1058 14.7694 10.4266 -10.5567 0.791778 1.58055 +586 1 6.78603 6.87835 15.4866 -3.36028 4.68136 22.1121 +587 2 7.71026 7.02894 15.2668 2.14313 -2.1467 -3.22881 +588 2 6.63472 7.41247 16.2893 -0.664868 -8.24615 -12.946 +589 1 7.99755 4.5041 13.3499 24.8278 34.1767 5.68201 +590 2 7.17338 4.66838 12.8997 -9.34484 -1.26894 -9.57598 +591 2 8.42297 5.40326 13.4231 -14.2483 -32.2403 1.51042 +592 1 13.3614 12.2059 14.3726 -2.68828 -3.01756 -2.25781 +593 2 13.124 11.2722 14.2967 -0.0467593 -0.437755 2.8377 +594 2 13.7081 12.4264 13.5024 2.10157 3.54991 -1.69903 +595 1 14.5654 9.5448 7.2719 7.4337 1.87458 1.84958 +596 2 15.4192 9.97446 7.42049 -0.421966 -1.69006 0.109976 +597 2 13.9603 9.96019 7.88547 -6.00597 1.06642 2.40823 +598 1 12.7021 16.8399 3.28406 2.1329 2.22559 -4.89416 +599 2 12.9627 17.2776 4.09814 -1.16793 0.633127 5.57798 +600 2 12.5029 17.5595 2.67417 -2.21511 -1.15635 -1.62469 +601 1 1.01088 7.06774 17.3689 20.0897 -7.47151 2.1243 +602 2 0.171968 6.83932 17.7636 -13.4375 4.7826 3.09836 +603 2 0.861358 7.69882 16.662 -3.49993 1.38105 -6.69635 +604 1 12.9265 4.90969 15.692 -1.72339 7.7777 5.20839 +605 2 13.7461 4.44088 15.8455 2.50132 -9.36464 -4.69309 +606 2 13.1831 5.83499 15.7716 0.254864 4.72294 -0.0726576 +607 1 2.3277 3.38915 5.11911 5.08689 -5.27649 -8.37414 +608 2 1.81648 3.03652 5.84872 -5.99705 -1.71944 1.12123 +609 2 2.79757 4.13118 5.49603 6.03185 12.6803 -1.33855 +610 1 8.22299 10.983 13.6596 -2.68868 6.78672 22.55 +611 2 8.37046 10.9349 14.6227 -7.71168 -0.54916 -12.6902 +612 2 9.06889 10.7219 13.2955 2.07822 -5.6604 -8.58071 +613 1 12.9566 1.54883 13.2404 -6.45532 19.0424 -4.61407 +614 2 13.4436 1.59622 12.409 4.66376 -6.5769 4.30334 +615 2 12.5511 2.44176 13.2892 3.97521 -19.3883 2.5587 +616 1 6.59697 13.6382 2.12308 -19.53 14.6785 -2.92569 +617 2 5.9569 13.9305 2.80289 7.92829 -3.31956 -9.9577 +618 2 7.23585 13.1086 2.59101 5.128 -6.56439 5.02766 +619 1 15.8657 6.47234 12.6041 4.99369 -6.06314 4.28807 +620 2 16.4551 6.98041 12.0348 -2.62867 1.80518 0.0955392 +621 2 16.3109 6.45259 13.4696 -4.62358 3.40022 -7.66147 +622 1 16.7868 0.706192 9.5524 8.10763 10.4692 12.0206 +623 2 16.4993 18.5236 9.95191 3.55616 -11.3811 -4.24312 +624 2 16.3059 0.843102 8.73445 -6.13335 -2.9453 -10.1224 +625 1 6.15553 11.6636 8.28166 8.04937 9.43191 -5.2183 +626 2 5.38812 11.3133 8.7152 -15.4132 0.789816 9.90132 +627 2 6.60546 10.8728 7.99206 7.62403 -6.5238 -2.76924 +628 1 2.80481 8.67956 0.357522 -16.6853 -5.97365 -15.2844 +629 2 2.27492 8.26466 18.2845 10.7138 4.85897 15.9492 +630 2 2.22127 9.36062 0.722932 4.52332 -2.29686 2.25001 +631 1 10.1103 10.3863 6.60128 -6.60242 -1.42487 -6.12592 +632 2 10.6136 9.70804 7.05871 2.40377 -4.05953 3.76861 +633 2 10.2954 10.2785 5.66001 4.13032 2.32994 2.59513 +634 1 6.85077 15.7563 6.70738 -11.7521 -4.07497 3.77538 +635 2 6.99262 16.2462 7.53077 3.71638 -1.24183 -4.26209 +636 2 6.92978 16.3894 5.98454 6.68147 0.141382 -0.214337 +637 1 6.48958 12.9529 5.78988 1.80967 -1.32299 -1.48619 +638 2 6.5811 13.8382 6.15183 4.24501 4.33378 1.70513 +639 2 6.11675 12.413 6.49523 0.159424 2.05888 1.44919 +640 1 16.7629 12.5191 9.71336 -1.62109 -11.3708 1.97787 +641 2 17.0324 11.8284 9.09183 -7.38478 2.50021 2.06117 +642 2 17.4395 13.1763 9.61316 3.98731 12.5093 -0.628579 +643 1 6.20997 2.89816 2.77935 -0.0802363 -5.63791 0.773513 +644 2 6.61167 3.74714 2.54082 -9.15989 -2.58724 -3.98308 +645 2 5.63039 2.60429 2.05445 8.60419 4.25286 3.07741 +646 1 10.7636 3.09526 3.23748 -2.12809 -1.19847 1.63085 +647 2 10.0581 3.70038 3.49376 4.9418 2.80865 -0.749542 +648 2 10.4122 2.60071 2.48751 -0.504171 1.44253 0.108713 +ITEM: TIMESTEP +80 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.8014 6.74321 17.9894 -25.71 0.163943 4.88408 +2 2 7.93592 6.85831 18.4426 18.3019 -2.2716 -9.29 +3 2 8.62145 6.12739 17.2721 4.06901 -0.284928 0.869098 +4 1 0.193099 8.36013 6.75275 5.74913 -14.5769 25.1987 +5 2 0.349094 8.05034 5.86501 -0.249861 0.708817 -17.2091 +6 2 0.558161 7.64099 7.32168 -7.5605 18.9357 -7.69302 +7 1 8.61156 0.29086 6.89037 18.8351 -6.84677 1.91716 +8 2 9.54524 0.192133 6.6105 -17.2936 6.40231 3.46958 +9 2 8.24205 0.986486 6.33979 -0.485036 0.67975 -2.4356 +10 1 6.46061 1.74084 11.7563 18.0716 -9.05138 -10.6926 +11 2 5.90902 2.36746 12.1907 -18.8993 15.6687 11.8916 +12 2 5.86943 1.07894 11.3852 -0.461453 -6.159 1.34784 +13 1 6.94761 5.53992 2.37529 -6.07193 26.0011 19.9509 +14 2 6.56484 5.89454 3.23997 6.76459 -12.0871 -41.8379 +15 2 6.81469 6.2225 1.67437 0.333839 -16.9501 17.8189 +16 1 16.2464 10.2212 16.095 -30.9636 -1.96085 19.7441 +17 2 16.8891 10.4896 15.4774 30.9665 9.88757 -18.0257 +18 2 15.7638 11.031 16.3423 6.62567 -11.9253 -3.68232 +19 1 10.7594 14.9468 2.28506 -10.192 -15.3258 -5.27915 +20 2 10.552 14.3194 2.98639 5.50444 -0.296801 2.35986 +21 2 11.1642 15.6696 2.7411 11.3222 17.7739 6.10774 +22 1 17.1862 8.22111 10.8759 16.4539 0.643281 -9.91552 +23 2 16.576 8.81969 11.3105 -3.64966 6.67804 4.28607 +24 2 17.949 8.77387 10.614 -8.44523 -5.92405 1.0378 +25 1 14.6358 16.0024 16.3895 25.5058 -11.0228 4.42293 +26 2 13.7352 16.2786 16.3126 -22.3429 5.97271 0.576342 +27 2 14.7081 15.5263 17.2386 -3.54281 4.69451 -12.0743 +28 1 12.1273 13.3164 0.564829 -0.361627 4.24339 0.0908299 +29 2 11.7754 13.443 18.3303 1.85705 -5.04776 -15.4247 +30 2 11.6653 13.9884 1.07404 2.42612 -1.45379 10.2607 +31 1 9.30563 5.48822 3.87958 6.5447 0.0363683 25.4904 +32 2 8.87806 5.40536 4.77034 1.54217 -0.907852 -25.4465 +33 2 8.62277 5.52424 3.19838 -5.81373 -1.17005 3.72822 +34 1 1.59219 3.96918 11.5778 -9.84269 42.1113 -23.7424 +35 2 1.65598 4.94531 11.7448 -5.32168 -23.4604 1.30407 +36 2 2.08682 3.52502 12.2368 16.8537 -14.859 24.6718 +37 1 2.0876 6.92307 8.18563 -3.73767 -8.57072 -0.0346284 +38 2 2.39381 7.30463 9.00964 5.23298 7.68032 1.6714 +39 2 2.09597 5.97338 8.35948 -3.7573 0.82597 0.238295 +40 1 5.28961 4.49122 7.85762 -5.23337 8.41869 1.15392 +41 2 5.42981 3.54006 7.92701 -4.09922 -6.37036 -7.26013 +42 2 4.64396 4.70759 7.15783 7.0556 -5.183 4.67383 +43 1 3.36027 2.89954 17.3915 -17.4395 12.4687 22.0366 +44 2 4.05476 3.43419 17.006 5.24509 0.828911 -8.29254 +45 2 2.77379 3.5226 17.8911 18.871 -11.3769 -11.5396 +46 1 7.49453 5.42535 6.18785 1.1565 -0.337813 22.5495 +47 2 7.9164 5.96716 6.90215 -9.87324 -14.4944 -23.4171 +48 2 6.89327 4.79051 6.63979 12.0833 17.318 -7.46699 +49 1 9.81909 7.02563 12.0706 7.31099 -1.858 8.99458 +50 2 10.1534 6.27284 11.5881 4.21769 -4.6772 -1.38273 +51 2 9.09614 7.33889 11.5389 -11.6555 6.63577 -10.586 +52 1 13.987 3.72336 8.09074 -16.8343 16.962 -37.2017 +53 2 13.5442 4.52839 7.7245 12.4076 -19.615 9.33911 +54 2 14.2201 3.91921 8.97962 7.00657 7.67382 26.2916 +55 1 4.5104 17.1281 3.91533 10.7578 31.6451 -21.4766 +56 2 5.3439 17.6347 3.91183 -5.56531 -14.4645 11.3324 +57 2 4.01019 17.58 3.20396 0.717673 -14.6313 13.083 +58 1 16.3456 16.5752 10.4878 9.47486 -6.83722 -28.8723 +59 2 15.5139 16.524 10.9378 -17.3385 1.90191 12.1775 +60 2 16.1667 16.1386 9.62748 3.54118 4.50203 14.5107 +61 1 1.9669 4.78352 0.127126 -0.739304 -4.30462 13.1261 +62 2 2.4124 5.1813 0.904759 -4.07407 -0.50297 -16.3737 +63 2 1.70825 5.48663 18.1668 4.40273 7.87995 3.28325 +64 1 11.3312 13.2592 16.4181 -1.15069 -16.7597 -15.9919 +65 2 10.8158 12.4247 16.4648 10.4615 17.429 3.38388 +66 2 11.9137 13.1122 15.6483 -5.75273 4.84583 10.0297 +67 1 10.0951 10.9476 16.7865 12.4257 -21.5163 1.40398 +68 2 10.4762 10.0399 16.7888 -6.98476 25.4172 2.00859 +69 2 9.15392 10.8219 16.7533 -12.5538 0.302602 -1.38706 +70 1 11.8287 17.486 13.4829 -0.118354 -13.6364 7.15806 +71 2 12.4458 16.8683 13.0504 -5.40922 13.24 -3.88075 +72 2 12.1685 18.3769 13.3708 4.2975 6.3924 -3.60834 +73 1 6.40329 9.45666 12.3007 7.59953 -15.5921 -26.3915 +74 2 7.02951 9.14458 11.6116 -13.6176 6.52201 11.0115 +75 2 6.95635 9.88774 12.9378 9.38595 10.7935 13.1394 +76 1 16.3024 12.9052 2.74142 -15.9403 -16.7132 8.77179 +77 2 17.1501 13.3041 2.5727 9.16723 7.57391 -3.15506 +78 2 15.6647 13.6204 2.85813 1.6204 2.22565 -2.39426 +79 1 0.760847 12.751 5.87222 -24.7031 -12.948 -13.3423 +80 2 1.12648 12.6956 4.9713 -1.82207 2.12621 9.26767 +81 2 18.4428 12.5289 5.74368 26.1358 12.2861 6.31515 +82 1 5.29492 16.3822 18.4146 -5.77927 -1.1636 -2.25588 +83 2 5.45161 15.4933 18.0434 4.5004 13.3336 10.181 +84 2 5.72207 16.4863 0.6292 0.349856 -6.54957 -3.00829 +85 1 0.672446 7.71977 4.17015 11.9206 5.83738 -2.65809 +86 2 0.0599114 7.99601 3.47788 2.17241 0.0211014 0.560686 +87 2 1.51354 8.18303 3.96741 -13.409 -12.9126 0.0558484 +88 1 3.18041 9.04016 6.47644 -48.733 9.26031 0.132627 +89 2 3.67612 8.69495 7.19851 13.8171 -10.3779 15.348 +90 2 2.22175 8.86945 6.71565 32.4894 5.10639 -10.1715 +91 1 7.33809 10.425 16.1982 -13.7714 -1.76245 23.4597 +92 2 6.52669 10.798 15.8343 6.52641 -1.5478 0.375626 +93 2 7.11414 10.2397 17.1395 3.58358 2.1532 -21.3577 +94 1 11.0368 0.910412 5.00755 -5.03762 -2.37072 -20.9965 +95 2 11.0166 1.76948 4.5572 3.99116 -0.122414 9.27702 +96 2 10.8085 0.318039 4.26499 2.41704 1.78329 12.9529 +97 1 4.27055 2.90822 13.1584 -5.03414 2.69466 11.7405 +98 2 4.39065 3.48249 13.9384 2.16314 -12.4788 -5.29849 +99 2 4.11656 2.00207 13.4974 4.2297 10.0998 -5.7581 +100 1 8.47529 10.248 1.79037 -0.416679 -17.2671 7.19176 +101 2 8.23967 10.8662 2.49257 2.8179 1.08296 2.51337 +102 2 8.59639 9.37915 2.23271 0.0130336 16.1865 -5.8343 +103 1 10.3383 1.70852 15.4843 -18.7352 2.46602 -2.29408 +104 2 11.1863 1.36274 15.7269 17.9639 -3.17473 -1.31836 +105 2 10.261 1.74525 14.5183 4.02029 2.26456 4.98686 +106 1 2.61381 12.97 7.91629 0.377646 -9.00714 -10.2558 +107 2 3.20736 13.521 7.38885 -1.73045 4.27865 2.80704 +108 2 1.92972 12.6563 7.30106 5.76016 2.06086 0.889789 +109 1 3.8265 11.6489 4.94253 -18.049 0.292651 15.0893 +110 2 3.64515 11.1228 5.74952 0.240622 6.04317 -17.8646 +111 2 3.00147 11.7074 4.41136 14.7829 -0.870145 11.9003 +112 1 6.67003 14.5068 16.9871 0.195301 -8.52391 -8.20479 +113 2 7.30673 15.1853 17.2075 3.81359 1.00594 1.02421 +114 2 6.51415 14.5784 16.0351 -3.74805 4.58221 3.23833 +115 1 14.2005 14.4991 3.2542 12.2104 -4.1759 -13.149 +116 2 13.9664 15.4191 3.35064 -8.52353 7.22912 -0.280994 +117 2 13.8358 14.0368 4.00136 -6.61808 -5.66537 10.7242 +118 1 8.64986 18.0488 16.0994 -35.3958 -9.60596 -0.188096 +119 2 9.08138 17.255 16.4541 14.3634 13.9351 -5.51429 +120 2 9.16615 0.19969 15.9552 18.9441 -0.541676 3.30098 +121 1 4.69447 1.75392 4.88991 25.859 26.3088 -12.7751 +122 2 3.87089 2.24691 4.93296 -3.58784 0.203107 2.94233 +123 2 5.32887 2.35869 4.40805 -22.2668 -23.8988 10.2256 +124 1 15.0337 12.5563 16.5322 -9.42235 19.0778 45.1845 +125 2 14.5415 12.8308 17.3429 25.2588 -5.91919 -13.7907 +126 2 14.3516 12.6025 15.8912 -15.7131 -4.7436 -33.7881 +127 1 15.7107 18.4933 16.8499 14.0119 15.6823 26.0515 +128 2 16.2364 18.5256 17.6977 -11.7154 -4.95338 -28.5838 +129 2 15.2517 17.6535 16.8181 2.70767 -12.4638 1.72062 +130 1 1.36288 1.31672 16.6317 -8.11361 12.6727 12.78 +131 2 2.12452 1.88684 16.8387 -7.41596 -12.3761 -6.73343 +132 2 0.666274 1.64987 17.2352 10.0682 -8.10993 -10.4284 +133 1 18.2119 4.36953 15.9172 -1.70541 -5.24792 -22.7614 +134 2 17.9042 3.81192 15.1707 6.44647 9.66147 16.3107 +135 2 0.476259 4.62247 15.7042 -5.76089 -2.38794 2.9761 +136 1 12.1484 17.0613 16.1489 -25.1744 -26.2572 32.1897 +137 2 11.4087 16.4938 16.5203 28.1495 25.8696 -8.33389 +138 2 11.9925 17.0682 15.2174 -4.06343 5.18838 -23.7308 +139 1 16.1307 2.63053 18.236 -24.4255 7.46546 -12.7341 +140 2 15.654 3.45006 18.4862 10.3096 -12.6534 -4.96798 +141 2 15.8825 2.42572 17.3162 0.942238 5.76458 9.76029 +142 1 6.69125 13.7819 10.0957 6.51523 5.30674 14.72 +143 2 6.68166 13.4115 10.9958 -3.31201 0.605957 -8.104 +144 2 6.74207 13.0463 9.48799 -5.76864 -9.77159 -4.40801 +145 1 10.1909 18.4566 2.69612 24.6552 12.5235 -11.9688 +146 2 10.5208 0.299966 1.90483 -6.63917 -6.88653 20.5003 +147 2 9.33855 18.1401 2.45819 -23.0922 -9.86885 -6.30041 +148 1 3.05041 17.6833 6.1612 -20.7399 0.346779 9.3758 +149 2 2.11766 17.6882 5.81771 32.7543 -5.44367 1.96306 +150 2 3.663 17.6288 5.4193 -6.60477 0.357372 -5.21379 +151 1 12.6301 16.8021 7.91443 2.73044 3.22351 -7.20597 +152 2 11.8394 16.2829 7.68186 3.48899 3.70212 12.2186 +153 2 12.4619 17.4281 8.63963 -10.075 -5.48551 -5.536 +154 1 14.8863 15.2402 8.20999 -23.6436 14.8183 29.3151 +155 2 14.1404 15.8836 8.27066 14.7388 -14.8318 -6.56535 +156 2 15.2763 15.3549 7.35467 9.52302 6.19548 -12.651 +157 1 17.8321 18.2493 0.273835 -34.2521 -9.59248 -4.32979 +158 2 18.5224 17.6645 -0.0392514 10.753 2.02465 3.4369 +159 2 18.2087 0.412934 0.595185 14.0613 13.0178 4.00109 +160 1 0.763956 10.5262 1.39925 -10.0074 -57.9186 33.1602 +161 2 0.0205775 9.86382 1.5781 27.9288 29.6193 -5.5527 +162 2 0.446448 11.1766 0.811593 -14.5912 25.5328 -23.4764 +163 1 1.80037 12.2889 3.30512 5.17734 11.597 19.2466 +164 2 1.46139 11.5987 2.74824 -6.10095 -9.75588 -16.5262 +165 2 2.13675 13.0044 2.75129 -3.9772 -2.70365 -1.85909 +166 1 0.682885 17.2588 4.99366 18.5034 24.5267 -32.7679 +167 2 0.107172 18.0117 5.16246 -8.54671 -5.12892 6.2039 +168 2 0.50047 16.4742 5.48014 -13.5055 -14.6224 21.6265 +169 1 1.0645 0.823506 9.34737 11.8193 5.83131 5.68962 +170 2 1.36557 0.594309 10.2448 -8.52979 0.55273 -0.975829 +171 2 0.153783 0.559257 9.28231 -13.2671 -5.76719 2.40467 +172 1 16.771 2.35127 13.3608 4.58635 29.8799 -13.6101 +173 2 16.8279 2.7166 12.4388 1.57782 -15.3367 24.752 +174 2 16.4858 1.44141 13.3191 -2.28737 -11.3359 -2.05688 +175 1 2.68433 15.9539 12.0479 2.00481 -8.12072 21.99 +176 2 2.97356 15.5639 12.9056 -4.45908 8.74231 -22.8774 +177 2 3.1524 15.4962 11.3314 -4.16555 3.83231 7.28649 +178 1 16.3902 15.5703 6.15458 18.8333 21.1033 -24.533 +179 2 17.3221 15.5371 6.43733 -15.6071 -4.56317 -0.523174 +180 2 16.3697 16.3474 5.53712 -7.15193 -24.3314 15.8574 +181 1 5.78808 5.16844 11.811 1.07675 -5.38543 -7.05048 +182 2 5.68145 6.03537 12.2081 -3.48533 4.06917 4.5041 +183 2 5.0592 4.65006 12.1655 2.16361 -4.54815 -2.94322 +184 1 15.172 4.89144 0.795633 -0.620892 -0.594882 26.39 +185 2 14.9156 4.81116 1.75201 7.19669 -4.64536 -26.7766 +186 2 14.3985 5.20255 0.336699 -8.8444 5.20324 -3.46854 +187 1 16.3986 16.4119 1.90339 15.122 14.6556 -26.5352 +188 2 16.0454 16.7612 2.71133 -6.27107 5.29423 17.303 +189 2 16.8063 17.1873 1.44657 -8.45441 -18.3773 8.08233 +190 1 0.184762 4.82044 3.92309 -20.0167 36.2337 -7.4234 +191 2 0.305381 5.80234 3.92557 1.42835 -23.0136 0.864842 +192 2 1.01251 4.4465 4.18098 17.0496 -9.16948 9.65169 +193 1 2.95853 15.072 15.1235 -0.929158 -18.0667 1.08146 +194 2 2.81752 14.526 15.9315 -1.93517 21.6459 -9.19578 +195 2 2.47159 15.9015 15.2035 -0.281788 -0.150795 8.17547 +196 1 1.08884 14.6409 9.4443 27.3966 -12.5379 -34.1186 +197 2 1.70575 13.947 9.05916 -23.9186 28.888 17.798 +198 2 0.66831 14.2301 10.1769 -7.64803 -12.9163 21.0233 +199 1 13.5173 16.5215 11.5364 0.489599 15.4909 -5.38356 +200 2 13.0836 17.2895 11.1076 8.88627 -7.75363 7.54599 +201 2 13.0704 15.7764 11.1287 -2.36322 -6.26123 2.87696 +202 1 4.73898 1.52078 0.69167 -9.68217 -10.6702 17.6377 +203 2 4.07875 2.00526 0.184075 4.46446 1.98443 -3.98397 +204 2 4.22033 0.928191 1.27988 9.48282 8.28471 -14.387 +205 1 1.52478 18.5784 11.9214 -16.2358 21.4234 -4.1613 +206 2 1.51367 0.493465 12.7143 -0.730917 -3.29007 -5.80239 +207 2 2.22048 17.951 12.0321 13.8924 -17.5303 6.45556 +208 1 11.4148 10.1041 4.08036 9.63761 14.6797 -7.17105 +209 2 11.6092 10.6619 3.28786 -9.14527 -18.7957 16.2306 +210 2 12.2661 9.96891 4.5224 -0.931524 1.73008 -8.63915 +211 1 8.18373 12.2132 3.70486 4.04638 8.18109 41.2935 +212 2 9.0456 12.58 3.98139 -6.62274 -6.35725 -9.04284 +213 2 7.64552 12.2934 4.54 8.66084 -3.68417 -28.5646 +214 1 14.5934 4.00277 3.33714 14.4882 6.32576 -0.110592 +215 2 15.3087 4.27672 3.93937 -11.245 -6.6719 -0.591331 +216 2 13.7777 4.36055 3.68688 -6.37652 3.17854 3.04506 +217 1 5.71814 1.6621 7.57513 -5.5313 -4.02265 40.0153 +218 2 5.00295 1.12677 7.97081 8.59667 7.25176 -1.51046 +219 2 5.48447 1.71188 6.6706 -7.03261 -0.519715 -37.0679 +220 1 17.8819 0.996597 4.84385 3.28334 1.22129 -8.70029 +221 2 18.3735 1.40853 4.10428 -5.78677 -2.02928 14.9184 +222 2 17.7642 1.64161 5.55539 2.20556 -0.0657175 -7.03701 +223 1 6.81886 9.28778 4.52861 6.25722 -6.76526 -10.2791 +224 2 6.61832 9.39383 5.45723 -0.00817066 1.76549 8.49843 +225 2 7.7574 9.04758 4.4954 -4.05712 -0.0763234 -2.03313 +226 1 2.4854 14.759 2.04442 -7.64745 -7.92423 -28.9185 +227 2 3.31932 14.7218 2.51092 7.63377 -1.04104 5.23896 +228 2 2.65881 14.5612 1.09422 1.17207 5.04057 23.1132 +229 1 17.2643 12.9213 13.1026 -19.9619 15.9168 2.25648 +230 2 16.3761 13.2301 13.4207 25.7036 -1.66639 -12.6722 +231 2 17.7779 13.7212 12.8621 -11.3949 -9.92691 5.05246 +232 1 14.8558 10.5579 1.44832 -24.1837 -11.6243 -0.0449549 +233 2 15.2498 11.3496 1.79784 9.85962 12.147 5.79114 +234 2 13.9164 10.5877 1.7065 14.7293 1.68269 -5.02708 +235 1 5.67033 6.62258 4.57309 8.95784 -16.3381 4.76769 +236 2 5.78141 7.53495 4.33529 5.34224 19.3995 0.612293 +237 2 6.44538 6.37316 5.11369 -12.1071 3.69782 0.132968 +238 1 8.08484 8.3464 10.3723 -2.79238 1.81559 10.704 +239 2 8.60215 8.86766 9.74634 -1.18548 0.238269 1.84293 +240 2 7.34937 7.94467 9.9053 0.580319 -4.15939 -10.1337 +241 1 13.4382 18.465 5.66883 -2.12963 -16.204 3.95429 +242 2 12.6402 0.317353 5.43723 -0.0049589 1.74147 2.86213 +243 2 13.1409 17.7635 6.28441 4.99057 13.7489 -2.35078 +244 1 -0.0389125 2.60201 0.358484 20.6019 -11.619 5.06808 +245 2 17.6744 2.57403 18.7483 8.04315 12.368 -1.45646 +246 2 0.347515 3.47455 0.194182 -8.07269 -1.54831 -1.2857 +247 1 12.9609 10.9078 9.72363 -44.1168 29.5082 -8.54535 +248 2 11.9486 10.9818 9.7709 44.2995 -10.8859 -2.13595 +249 2 13.1901 10.0051 9.91101 -8.5598 -18.2315 3.87517 +250 1 0.590645 12.1909 11.1498 11.7969 16.2942 20.6903 +251 2 18.3214 12.2032 11.4307 -13.062 -2.39731 -5.9775 +252 2 1.05781 12.4788 11.9545 1.3761 -3.96073 -11.1532 +253 1 5.19979 7.35251 13.3459 4.96104 -3.5954 0.621761 +254 2 5.77554 8.05147 13.0099 -6.36891 3.58923 -1.12306 +255 2 5.62026 7.07364 14.1664 0.643961 -0.709679 0.08133 +256 1 1.17273 6.78721 11.9743 -37.7935 -22.2758 -19.6174 +257 2 0.361865 7.16229 11.5551 20.1673 -8.51661 10.9701 +258 2 1.7013 7.51605 12.2195 19.7686 31.2325 8.39364 +259 1 15.5313 9.74152 12.3525 -7.42661 26.8763 14.1834 +260 2 15.1354 10.6339 12.1691 17.2848 -32.3992 2.44097 +261 2 15.9001 9.83422 13.2442 -4.7827 -6.0868 -10.0384 +262 1 16.5842 12.6457 5.58229 -7.58554 26.2756 -26.1768 +263 2 16.3849 13.5701 5.8413 5.71516 -14.5282 0.0223018 +264 2 16.4193 12.6729 4.60395 6.10391 -10.0799 23.5706 +265 1 6.38601 9.81704 0.0456579 -23.7849 0.890546 -8.41533 +266 2 5.51671 10.1854 0.278669 9.54818 -0.234306 -0.813632 +267 2 7.00687 10.1562 0.67255 15.5644 7.03716 17.2844 +268 1 12.2684 6.05846 4.00919 -28.2934 -33.3926 21.5663 +269 2 12.263 6.7861 3.41661 0.234348 22.4834 -18.769 +270 2 11.3224 5.76736 4.06199 25.4812 4.82389 -2.50319 +271 1 0.373791 12.8792 0.072054 -11.107 3.80906 -1.77299 +272 2 18.9015 13.5268 0.779758 -5.73011 -3.33995 1.31101 +273 2 18.3694 13.1354 18.0395 6.43374 -1.82904 2.53089 +274 1 3.55692 18.7013 8.65073 14.893 -16.0199 -12.5754 +275 2 3.38339 18.1698 7.85699 7.36237 7.58391 1.53928 +276 2 2.68044 0.23403 8.96368 -11.3363 8.83032 5.06178 +277 1 7.32525 17.3963 4.4514 17.4309 29.7426 -3.23332 +278 2 7.82401 18.2131 4.74166 -23.0386 -26.7058 -8.39786 +279 2 7.43189 17.3694 3.48275 -1.39589 -2.42936 11.5599 +280 1 9.26525 17.1572 12.169 8.13396 -3.40366 20.592 +281 2 9.29678 16.2438 11.8433 -0.925088 7.81756 -3.33389 +282 2 9.96734 17.2329 12.8546 -10.0311 -2.0771 -17.5408 +283 1 13.2786 13.1508 8.01112 -12.5044 -28.1533 13.0431 +284 2 13.4287 12.5256 8.7581 -3.83031 10.1919 -19.0767 +285 2 13.9208 13.8439 8.10408 14.3758 9.62768 2.82629 +286 1 14.7717 2.95063 15.4663 23.0059 6.37496 -12.5686 +287 2 14.1149 2.31 15.1961 -5.56432 -5.96018 -2.11564 +288 2 15.3514 3.08539 14.6861 -8.35989 -8.63193 12.4086 +289 1 9.95789 15.6422 16.9764 -4.46993 0.793564 -8.8018 +290 2 10.2307 14.8148 16.5569 1.31144 -2.42354 4.42353 +291 2 9.44172 15.4 17.7473 1.0906 -3.95706 9.45227 +292 1 11.2531 8.54113 16.6333 5.17657 0.0418295 -8.84929 +293 2 10.6325 8.00272 16.1399 -5.6117 -5.11655 -0.169214 +294 2 11.5912 7.9918 17.3372 0.751532 -6.83429 5.96975 +295 1 4.09617 18.2775 16.8038 -1.75476 28.7193 2.74196 +296 2 4.5979 17.7227 17.3968 3.26159 -10.0112 3.6984 +297 2 4.13851 0.526798 17.2077 -3.53746 -18.1625 -9.44923 +298 1 2.30039 4.26982 8.91686 21.6694 -5.11589 23.5763 +299 2 3.26852 4.19272 8.75344 -21.2665 0.643644 3.82423 +300 2 2.17319 4.0769 9.88449 2.25335 4.47185 -28.5355 +301 1 9.91449 10.4045 9.82138 -1.36818 12.3774 -23.5261 +302 2 9.54718 11.2486 9.48103 5.13969 -13.6804 7.80682 +303 2 9.93694 10.4191 10.7736 0.214264 3.33848 13.7587 +304 1 9.74784 0.927945 10.8307 17.8645 8.52415 0.395599 +305 2 9.30432 0.217271 11.2949 -5.1784 -7.81016 -3.03012 +306 2 9.13824 1.32484 10.1982 -3.45577 -3.9008 2.04599 +307 1 9.17195 15.1281 10.2005 -15.5022 -1.44929 -2.09464 +308 2 8.96814 15.9769 9.77108 -2.08214 -7.76738 2.59404 +309 2 8.35001 14.5895 10.1068 18.2617 13.451 2.66111 +310 1 0.828362 9.74081 10.2167 22.8302 -4.53826 -35.6406 +311 2 0.863435 10.6794 10.4661 0.846835 -12.3508 -3.07098 +312 2 1.42185 9.63122 9.40918 -26.8549 6.26386 38.0517 +313 1 17.1622 4.86379 8.08044 2.41554 -11.1764 16.204 +314 2 16.3163 5.29453 8.26848 4.74994 -0.845127 5.21041 +315 2 17.4172 4.31929 8.8662 -8.72341 14.5987 -22.1578 +316 1 14.8039 14.6747 0.0449816 -17.091 -7.62196 19.0468 +317 2 15.3137 15.169 0.695817 3.50252 1.08273 0.82912 +318 2 14.0068 14.3765 0.533797 12.6241 2.78049 -10.2188 +319 1 3.85026 11.0642 9.5563 -2.44831 7.24975 -16.8488 +320 2 3.90516 11.4403 10.4374 -3.64435 1.57263 7.30128 +321 2 3.45144 11.7342 8.96857 -1.60708 -4.46554 10.9787 +322 1 11.3552 10.7376 1.50363 23.7004 17.8717 -7.90317 +323 2 11.5499 11.5913 1.05012 -4.60225 -16.5984 9.56505 +324 2 10.4091 10.6312 1.49605 -14.4596 -0.264671 -3.06241 +325 1 13.1456 7.20328 12.6021 -24.9249 -2.39855 5.22786 +326 2 14.066 6.96941 12.5913 17.2615 -6.20786 -1.13088 +327 2 12.6433 6.37391 12.7221 9.22616 8.00521 -2.5813 +328 1 9.63635 1.93928 0.908954 12.9918 3.25798 9.3487 +329 2 8.80616 1.72326 0.497356 -10.689 -0.461065 -8.23177 +330 2 10.2384 2.2422 0.224542 -0.105661 1.67982 -4.44056 +331 1 10.6547 13.4406 4.52244 4.65594 3.65244 26.3326 +332 2 11.5391 13.0824 4.73514 -13.2197 2.26822 -8.08889 +333 2 10.4444 13.96 5.32492 0.722291 -5.69425 -12.9779 +334 1 14.5068 1.61853 10.9473 1.56188 14.5139 4.90111 +335 2 15.3059 1.27791 10.528 -0.453964 2.70191 1.23402 +336 2 14.6742 2.57144 11.1203 -1.66622 -13.4066 -10.2612 +337 1 14.4999 12.0198 11.6401 -20.4 4.4823 -10.6844 +338 2 15.1901 12.5044 11.1683 0.00955556 -6.20474 -4.10181 +339 2 13.88 11.6279 10.9736 17.9431 15.8984 14.8698 +340 1 8.17874 5.12415 9.82106 -30.5984 10.5693 18.9492 +341 2 7.28241 5.07355 10.2519 27.6442 5.22023 -11.9731 +342 2 8.30253 4.26697 9.4335 2.62166 -17.6444 -4.58757 +343 1 1.47714 16.9429 18.4887 13.3148 33.7663 -28.6254 +344 2 1.86682 17.2437 17.6257 -9.89818 -8.00998 25.1444 +345 2 1.74527 16.0479 18.574 6.31239 -26.8006 -0.778427 +346 1 1.45374 17.3594 15.3268 42.8952 -1.15706 -0.811193 +347 2 1.42588 18.2136 15.749 -3.30828 11.7666 5.73369 +348 2 0.584657 17.0429 15.2318 -41.4551 -8.54136 -0.705167 +349 1 3.54007 5.76039 6.04888 -8.98595 6.80975 7.90297 +350 2 3.01039 6.43039 6.5207 7.85999 -10.8756 -2.65394 +351 2 4.1622 6.27284 5.52252 1.18276 -3.83664 -2.43702 +352 1 12.5413 9.50789 14.2278 14.1386 -34.2774 -1.94842 +353 2 12.9806 8.74877 13.7665 -10.1246 23.4373 5.48687 +354 2 12.3781 9.12309 15.104 -2.49329 10.5308 -3.54938 +355 1 4.07791 15.2392 7.05947 28.2061 -4.52306 7.60827 +356 2 3.62905 16.0551 6.82 -1.6925 3.55103 -3.37365 +357 2 5.05246 15.4367 7.04645 -25.4492 -3.49557 -3.60676 +358 1 0.767125 8.74429 15.1186 -1.35051 -1.02403 -4.71838 +359 2 0.502685 9.67668 15.1423 2.70563 -3.13172 -3.80763 +360 2 1.44028 8.65803 14.4206 -5.36892 5.64782 6.7911 +361 1 12.8556 8.29114 10.1154 40.5883 -11.1151 11.7349 +362 2 13.7543 7.93714 9.90509 -23.2563 4.30646 -4.77873 +363 2 12.8036 8.10553 11.059 -7.7965 -1.57596 0.639248 +364 1 15.3061 7.91627 3.47282 -42.6646 -27.0181 14.5138 +365 2 14.4087 7.67951 3.19876 7.83283 16.2655 -25.9683 +366 2 15.288 7.37548 4.27198 30.0578 14.5578 6.00353 +367 1 17.2193 6.75387 0.0348868 -24.2654 8.60155 -9.76068 +368 2 16.7331 5.97981 0.339573 3.08011 -1.47023 2.02216 +369 2 16.4984 7.35116 18.3587 20.6605 -10.5931 7.39935 +370 1 8.96527 6.96977 7.82312 -33.6536 -16.7811 13.5927 +371 2 9.86459 7.23854 7.79988 29.8916 7.79708 0.58286 +372 2 8.85329 6.36072 8.58482 2.84704 12.8992 -8.98126 +373 1 12.4369 0.615517 1.24835 5.12967 -8.6669 -10.2958 +374 2 13.1996 1.14046 1.50868 5.63 -3.81589 5.32704 +375 2 12.6841 0.248493 0.387703 -6.12727 4.87774 5.89397 +376 1 5.63437 15.0947 14.482 15.2573 18.1506 -1.5187 +377 2 4.74012 15.1756 14.8216 -5.87791 -1.19647 -0.853033 +378 2 5.96659 16.0211 14.4028 -4.19512 -21.3346 -4.32131 +379 1 3.78146 6.44452 1.71439 -10.0957 17.3086 -10.1533 +380 2 3.36154 7.20469 1.26344 3.84289 -8.07011 2.3383 +381 2 3.80108 6.73559 2.62781 1.97525 -3.80667 6.02801 +382 1 3.89131 11.3886 12.3597 10.4858 -4.45626 -8.95185 +383 2 4.75702 11.7925 12.5217 -6.56671 -1.88331 -0.935479 +384 2 3.25208 11.9718 12.7596 -7.39976 8.19237 6.18945 +385 1 5.30831 3.87649 15.7567 -11.2019 61.1278 12.0088 +386 2 6.01892 3.27998 15.6709 29.6235 -28.0721 -9.85567 +387 2 5.7476 4.76544 15.8793 -15.8563 -28.9516 -7.19779 +388 1 14.1175 10.173 4.66017 9.40425 -19.9217 -33.2768 +389 2 14.1461 9.82294 5.54158 6.86029 -3.38102 17.8715 +390 2 14.6328 9.51646 4.11155 -16.0552 24.3993 16.1239 +391 1 7.5636 17.329 9.02789 1.81886 -5.76611 4.78707 +392 2 6.9813 17.6417 9.74433 4.383 2.36677 -11.0761 +393 2 7.91242 18.0661 8.5041 -5.60089 1.56926 3.7162 +394 1 4.54646 14.4437 3.82391 2.35855 8.70422 24.1238 +395 2 4.58695 15.3758 4.17596 -1.73775 -31.732 -9.36156 +396 2 4.50325 13.8127 4.58585 2.14298 18.0212 -18.4803 +397 1 14.2437 7.3639 15.8726 24.9361 2.31774 6.81444 +398 2 15.0991 7.30759 15.3921 -17.5628 0.546592 9.39404 +399 2 14.5002 7.74932 16.7373 -8.89015 -4.19374 -15.8798 +400 1 3.04207 18.4209 1.96748 -18.4085 17.9201 24.7102 +401 2 2.5353 17.8449 1.40649 -4.22111 -10.717 -13.4847 +402 2 2.35407 0.262093 2.48798 16.8127 -9.3976 -15.4809 +403 1 7.96924 1.62215 4.56344 31.9424 -9.467 0.421552 +404 2 7.35201 1.92948 3.90341 -1.64239 4.88827 -11.6355 +405 2 8.85795 1.52282 4.13815 -26.2226 6.52533 8.08337 +406 1 2.457 14.1626 17.6995 -18.6259 -8.83368 10.0969 +407 2 1.68725 13.6009 17.9701 23.9808 13.2635 -8.93306 +408 2 3.24279 13.6711 17.9492 9.2771 -5.34798 1.51385 +409 1 0.927142 1.91914 13.8849 28.4694 2.81528 -14.4963 +410 2 1.17928 1.66855 14.7668 -1.31862 -2.11333 16.1229 +411 2 -0.00784116 2.01924 13.8762 -26.8609 -0.0423979 -2.90492 +412 1 4.3639 0.116891 13.871 19.5154 5.98388 -10.2249 +413 2 5.3312 18.592 13.8382 -18.25 -1.84578 0.0905254 +414 2 4.09014 18.5553 14.7613 -1.68072 -4.35498 12.29 +415 1 7.32185 0.935992 18.4254 -25.1976 4.88188 40.3736 +416 2 7.29261 0.583526 17.5599 3.22929 -13.7772 -30.1977 +417 2 6.39141 0.906009 18.7671 22.6248 8.40202 -10.9225 +418 1 15.9043 18.3822 13.9598 -30.4853 6.92778 -31.02 +419 2 14.9691 18.5865 13.6701 32.1757 -7.76669 18.1984 +420 2 15.9697 -0.290473 14.9111 -4.96086 4.78357 11.6174 +421 1 10.2566 4.62301 16.2429 -20.4053 -21.3362 -19.7333 +422 2 11.1923 4.47268 16.3843 6.75918 3.74651 0.0845893 +423 2 9.94726 3.80759 15.7722 8.97755 19.5704 18.0095 +424 1 15.9188 17.665 4.49409 -30.8876 16.8748 5.69015 +425 2 16.5463 18.3904 4.38809 -0.624131 1.21894 5.03495 +426 2 15.0755 18.0798 4.84388 28.6139 -15.2662 -13.1828 +427 1 6.9464 17.5119 13.903 30.1459 16.134 14.6047 +428 2 7.45538 17.7973 14.7126 -14.438 -11.5296 -22.8133 +429 2 7.62564 17.4897 13.1926 -14.0494 -3.94126 11.1274 +430 1 13.2241 6.43487 6.53037 -11.3028 -4.49966 -3.41689 +431 2 14.1722 6.56035 6.47079 5.41657 3.67276 -3.81812 +432 2 12.8747 6.35097 5.62176 7.42053 0.356932 11.8509 +433 1 7.85865 2.26615 9.45505 -4.28533 -3.16859 -37.0089 +434 2 7.29966 2.29372 10.2234 -12.0252 -4.85104 14.2867 +435 2 7.31757 1.89726 8.71059 11.6806 10.5906 18.7024 +436 1 15.1499 14.8389 13.7285 -7.78284 7.72319 0.275575 +437 2 14.8617 14.9509 14.6481 -0.524909 3.36892 -5.65775 +438 2 14.6832 15.507 13.1912 6.48748 -10.1003 7.43034 +439 1 9.39784 8.36731 3.82962 2.5344 -9.0015 0.237957 +440 2 10.2136 8.88179 3.87227 -2.41531 -0.25237 0.330419 +441 2 9.66909 7.4454 3.98022 -9.00345 8.8328 -4.59515 +442 1 17.7291 13.5977 16.4646 5.88425 13.7422 -6.32319 +443 2 16.779 13.4368 16.4502 -3.47507 3.66531 -1.64514 +444 2 17.9175 14.4327 15.9665 -10.227 -20.4783 11.0606 +445 1 4.89529 10.4518 2.85531 35.8078 -15.8912 -9.72696 +446 2 5.76001 10.066 3.12945 -20.0856 5.21459 -7.60385 +447 2 4.65599 10.9551 3.62329 -7.19184 9.4675 7.77805 +448 1 3.68184 8.40606 9.96257 -7.06038 -13.6752 25.4145 +449 2 3.73025 9.3314 9.75201 2.05841 13.8137 -4.67922 +450 2 3.5201 8.39907 10.9276 1.35511 -1.83367 -14.7667 +451 1 15.9506 6.91676 5.90036 8.23349 -12.8437 -5.59708 +452 2 16.7283 7.39089 6.23923 -5.44721 -6.23743 -4.31526 +453 2 16.2459 6.04307 5.54881 -4.37327 20.9496 12.2757 +454 1 15.2047 7.21919 9.02648 -8.23364 16.7266 -25.0777 +455 2 16.0013 7.62239 9.37026 6.97324 -0.496136 10.989 +456 2 14.9764 7.76869 8.23928 2.79192 -13.8116 16.1423 +457 1 6.18989 12.8346 12.7303 -2.33267 17.6694 7.57139 +458 2 6.82101 12.228 13.1265 8.54383 1.14333 3.13472 +459 2 6.09938 13.6243 13.3122 2.17121 -15.6415 -7.8487 +460 1 12.1177 4.51675 13.1173 40.066 24.623 8.84127 +461 2 12.3608 4.67527 14.0558 -10.9347 -6.25445 -11.8552 +462 2 11.2865 4.0907 13.0625 -30.7168 -15.659 3.72413 +463 1 11.4382 8.09379 7.90765 11.4031 -1.65515 0.349674 +464 2 12.1555 7.64923 7.40412 -12.1024 3.57709 12.4555 +465 2 11.7306 8.14579 8.84607 -3.22191 -0.660368 -24.1915 +466 1 17.0422 10.838 7.59458 18.8696 -14.9771 -17.3127 +467 2 17.8015 10.2845 7.30277 -16.9558 5.34042 10.7777 +468 2 16.8989 11.446 6.8574 -4.66599 0.747798 1.74373 +469 1 5.2881 18.0926 10.8094 -12.0199 -6.67836 -5.57022 +470 2 4.87565 17.5902 11.533 4.52174 5.42574 -9.9319 +471 2 4.66447 18.0398 10.0548 7.40461 3.40643 11.786 +472 1 7.61349 17.4864 1.6652 -5.64906 3.24499 15.5952 +473 2 7.84327 16.7088 1.17852 12.3306 -20.6776 -4.28559 +474 2 7.74119 18.1865 1.04014 -3.89506 18.5858 -12.7246 +475 1 1.91944 12.8991 13.6003 2.94725 10.7513 13.4495 +476 2 1.49936 12.2949 14.2301 -1.35275 4.24281 -4.32331 +477 2 2.12078 13.7179 14.107 -1.08361 -15.4355 -11.6139 +478 1 9.36899 6.74386 14.7638 -2.26814 18.4847 -3.39127 +479 2 9.81478 6.02606 15.213 8.95117 -11.473 0.808352 +480 2 9.85086 6.98618 13.9577 -2.76657 -9.1339 3.81591 +481 1 15.2853 4.27459 10.7783 -6.29839 -2.79317 -1.65183 +482 2 16.2088 4.11106 10.5808 3.62417 -3.44414 3.50356 +483 2 15.3067 4.91761 11.4912 -1.69264 4.92972 1.1484 +484 1 11.3393 6.23844 0.0959214 -19.2017 -19.0623 -2.27733 +485 2 11.4465 5.27934 18.8311 9.36926 7.99257 -4.22996 +486 2 10.3892 6.29463 18.5179 14.2332 9.643 5.73673 +487 1 18.5128 11.4549 14.9487 -3.47415 -8.47336 -12.1105 +488 2 18.0135 11.8846 14.234 9.23154 -3.06455 1.62932 +489 2 18.3213 12.0172 15.6945 1.79799 8.69016 10.3557 +490 1 7.01602 9.27569 7.3226 -14.4634 -16.8581 15.1781 +491 2 6.67273 8.48369 7.80259 5.98597 16.4947 -15.5019 +492 2 7.96023 9.16216 7.29002 13.6661 -3.40194 -2.89589 +493 1 18.3593 15.3216 12.2421 14.2565 8.37053 -9.09139 +494 2 0.609114 15.6531 12.0121 -9.26774 -5.34503 6.02371 +495 2 17.7657 15.7501 11.6106 -0.96984 1.15192 3.02291 +496 1 16.5123 4.36636 5.2899 -20.1169 0.0802899 32.1896 +497 2 16.6197 4.39367 6.27015 0.689823 -6.50354 -17.1519 +498 2 17.3637 4.55338 4.93619 30.7718 -0.208347 -14.1282 +499 1 17.7452 3.18489 10.789 3.81546 21.3325 5.47337 +500 2 18.6747 3.34524 11.0396 -11.7638 -6.52287 -4.76545 +501 2 17.6832 2.38146 10.2881 5.2294 -17.628 -7.02183 +502 1 12.3161 18.6216 10.0891 7.2643 12.1904 3.38538 +503 2 11.4836 0.405415 10.3905 15.4316 -4.87983 -6.88019 +504 2 13.0526 0.636416 10.1289 -21.6037 -8.70048 2.57237 +505 1 10.3866 9.75789 12.4872 13.2725 15.9888 14.5072 +506 2 11.1625 9.86545 13.086 -15.7493 -4.39745 -10.7974 +507 2 10.2528 8.81785 12.4 2.63286 -10.7197 -2.15993 +508 1 0.710964 2.68685 7.1375 -0.1398 22.218 7.12103 +509 2 0.988905 3.47272 7.66294 -4.49485 -18.6961 -10.7978 +510 2 0.93208 1.94131 7.68754 4.63119 -8.38422 8.20051 +511 1 0.281684 15.3172 6.85959 12.828 -38.7344 -20.2135 +512 2 0.500898 15.7193 7.67574 7.5107 6.97721 30.9172 +513 2 0.662709 14.3998 6.92418 -16.2289 29.7866 -9.89698 +514 1 17.0547 6.94606 15.0133 0.165691 -3.90506 -0.393601 +515 2 17.812 7.5465 14.9118 -2.55694 -6.08978 1.76467 +516 2 17.3809 6.10212 15.3719 1.63232 8.8395 -1.4121 +517 1 9.12112 12.493 8.02809 -41.9273 18.4298 17.1595 +518 2 9.51251 11.917 7.38329 0.012751 -17.4797 -14.5944 +519 2 8.13115 12.5622 7.88239 38.3085 -7.50107 -2.24579 +520 1 1.15265 1.71178 2.84381 -8.4531 -11.9611 -9.59212 +521 2 1.05399 2.26522 2.05124 -0.803687 -1.8039 9.5303 +522 2 1.83355 2.04817 3.41993 6.13064 16.5152 3.77918 +523 1 4.1533 15.0772 10.0179 -3.20174 -0.437736 -9.29092 +524 2 3.98656 15.1016 9.06421 1.0299 1.2944 4.52592 +525 2 5.05261 14.7702 10.1253 7.00528 -3.42074 -2.93025 +526 1 7.40026 2.22746 14.7687 6.49168 5.19513 -3.0061 +527 2 7.05161 1.63346 14.1063 -3.12724 -4.90201 -3.09738 +528 2 7.91685 2.87588 14.258 -12.5256 -3.95349 11.2802 +529 1 18.373 14.546 2.1576 32.8202 -8.56769 3.71586 +530 2 0.641523 14.7991 2.40659 -13.3331 -4.12423 -2.43111 +531 2 17.8688 15.3457 2.17573 -14.9783 16.0191 -2.18472 +532 1 10.0269 2.72027 12.9069 6.62939 -13.0178 -15.3878 +533 2 10.0552 2.15154 12.1041 -3.85604 9.52515 15.5624 +534 2 9.22213 3.24102 12.837 -1.7712 4.41938 -1.42751 +535 1 2.97754 8.87028 12.9985 -9.05038 -0.677068 -3.47801 +536 2 3.45417 9.69118 12.8049 -4.31376 -0.734034 1.18179 +537 2 3.62806 8.2766 13.3769 7.01874 -2.97808 -1.19575 +538 1 3.19567 8.6035 3.77658 -19.8399 -15.185 62.8422 +539 2 3.69787 9.2024 3.27039 20.7823 26.7884 -21.1607 +540 2 3.25417 8.93577 4.73429 1.71088 -18.6185 -45.3432 +541 1 5.68333 7.2353 8.59567 4.24349 7.94903 8.11652 +542 2 5.64033 6.27333 8.54735 -2.49289 0.630165 -0.0839225 +543 2 5.00997 7.53803 9.22801 3.10928 -6.89318 -6.51723 +544 1 14.901 1.57394 1.8387 15.5968 1.99798 -17.643 +545 2 15.036 2.2757 2.46438 -7.07983 8.8607 13.8203 +546 2 15.4483 1.85956 1.08282 -11.9705 -11.4344 6.74504 +547 1 8.60581 15.0641 0.724175 -1.0343 -0.581701 -1.65436 +548 2 9.36267 14.9264 1.3224 -11.0408 7.07619 -5.07103 +549 2 7.85377 14.5885 1.11097 4.42293 -0.805501 -0.698164 +550 1 15.4669 1.42093 7.20398 -6.02567 -16.758 -12.9624 +551 2 14.8047 0.91537 6.67859 11.4397 13.2212 12.6179 +552 2 15.1632 2.33261 7.23494 -7.42764 0.585266 4.6538 +553 1 4.96609 12.9239 18.4605 4.9692 1.49742 18.5571 +554 2 5.35493 12.9668 0.719228 -7.36506 -0.705061 -15.6984 +555 2 5.64055 13.3191 17.899 -0.422768 -0.432726 -0.922633 +556 1 15.3869 8.64959 18.0541 15.2167 5.00615 -15.1922 +557 2 15.9585 9.21901 17.4831 -18.3202 -12.4364 12.18 +558 2 15.1184 9.19177 0.153179 1.36579 6.92031 5.44875 +559 1 12.0051 3.11685 18.332 2.92261 2.37371 -0.430118 +560 2 12.2267 2.91556 0.611981 0.907964 -7.8545 -12.3252 +561 2 12.4512 2.48545 17.7302 -5.34745 5.71129 14.8863 +562 1 13.1901 12.7142 5.17454 1.37013 -5.58194 -4.10925 +563 2 13.4698 11.8626 4.7966 3.05379 7.74077 7.48289 +564 2 13.3871 12.6804 6.11832 -0.290674 -0.040691 0.190289 +565 1 6.14326 7.19304 0.194857 -1.9202 -41.4233 1.79985 +566 2 6.22321 8.10871 19.0299 -3.97355 27.3971 1.06104 +567 2 5.34431 6.86352 0.645447 4.46952 5.26437 -3.48858 +568 1 17.7307 15.8888 14.9367 -21.823 -0.594011 -1.7362 +569 2 16.7484 15.9241 14.9389 21.2696 3.13718 0.352088 +570 2 17.9521 15.7271 14.013 1.78287 0.501162 -2.11552 +571 1 13.1218 0.925759 16.6825 5.50042 -3.78674 2.95198 +572 2 14.072 0.793445 16.8378 -4.97223 1.91263 -2.37602 +573 2 12.7827 0.0340456 16.5234 -2.01103 3.41826 1.69274 +574 1 10.8951 14.5133 7.41586 13.7556 -0.655539 -10.0126 +575 2 10.113 14.0867 7.762 -7.55253 -2.39401 4.078 +576 2 11.587 13.8348 7.46973 -1.14 7.89944 2.21203 +577 1 17.6887 8.43188 2.14728 0.189858 20.0466 16.1607 +578 2 16.8137 8.45099 2.54699 -1.17102 1.13639 1.13697 +579 2 17.5844 7.88298 1.39033 0.906265 -19.3865 -19.2668 +580 1 12.4753 7.78007 2.02858 4.8513 20.3782 0.840615 +581 2 12.1866 8.68618 1.79587 0.511972 -15.0552 5.00442 +582 2 12.026 7.17575 1.43189 -2.95773 1.13832 -8.42618 +583 1 12.0482 14.5597 10.5042 0.0757192 -7.5571 -35.1431 +584 2 12.4064 14.4181 9.58152 -17.4466 3.18024 31.1693 +585 2 11.0871 14.7065 10.4137 10.382 -0.64313 -2.04102 +586 1 6.77399 6.81718 15.4895 -2.25325 13.5751 22.5023 +587 2 7.66157 7.15195 15.2455 -13.2429 -8.30723 6.82645 +588 2 6.46823 7.3192 16.2828 11.602 -10.345 -19.2772 +589 1 7.96932 4.46689 13.3146 44.2968 21.2749 25.8476 +590 2 7.30275 4.56825 12.6635 -24.5307 9.83264 -18.6775 +591 2 8.36434 5.36687 13.4905 -14.8867 -29.3495 -5.61281 +592 1 13.3256 12.2141 14.3822 1.63527 0.767161 7.05401 +593 2 13.3071 11.2456 14.3976 -5.0343 3.13323 -4.4607 +594 2 13.6638 12.4664 13.5147 0.299935 -1.6824 -0.371902 +595 1 14.5332 9.57639 7.29372 1.70864 -17.4355 -8.36329 +596 2 15.3543 10.0193 7.49698 9.6305 7.8311 1.84335 +597 2 13.8455 10.0241 7.76467 -11.6358 9.67674 12.3645 +598 1 12.6873 16.8129 3.32056 7.83014 22.6359 -6.17069 +599 2 12.905 17.3242 4.12577 -3.6908 -4.91509 -14.526 +600 2 12.6713 17.4548 2.56832 -2.22777 -11.4506 21.1383 +601 1 1.00404 7.03926 17.3541 -3.3312 4.1638 -9.33324 +602 2 0.198847 6.6977 17.7452 -7.86562 1.94891 9.68399 +603 2 0.682364 7.69734 16.7196 12.0745 -4.24482 -2.37704 +604 1 12.9524 4.87174 15.7195 8.90342 0.650689 -3.85785 +605 2 13.7851 4.36673 15.5939 -16.3603 12.0475 7.07164 +606 2 13.1756 5.81397 15.8059 7.81047 -7.07308 -0.568692 +607 1 2.31363 3.41121 5.09984 1.34414 -8.27729 12.6429 +608 2 1.77118 2.94066 5.78541 14.4044 18.7697 -14.1923 +609 2 2.78995 4.15649 5.52715 -11.381 -10.4766 -6.15296 +610 1 8.18617 10.9369 13.7076 0.678078 1.53711 40.2692 +611 2 8.26353 10.8511 14.7174 0.0908521 -0.97824 -49.4206 +612 2 8.97116 10.5326 13.3071 -0.268246 2.83437 5.42064 +613 1 12.9797 1.57395 13.2253 -11.1668 13.2146 -3.30054 +614 2 13.4836 1.606 12.3812 -13.0456 2.80048 17.4401 +615 2 12.3844 2.37352 13.292 24.5144 -24.3843 -9.90982 +616 1 6.623 13.6575 2.08401 -19.1133 11.282 9.3836 +617 2 5.9939 13.9784 2.7781 14.9337 -6.87798 -17.2483 +618 2 7.26745 13.1178 2.55198 -2.04458 -0.845032 2.89429 +619 1 15.8406 6.42424 12.5401 -13.2713 -11.8586 11.2716 +620 2 16.4194 6.98592 12.0445 9.49352 10.2235 -13.5209 +621 2 16.1454 6.51524 13.4484 4.14662 -0.822673 1.52229 +622 1 16.7707 0.701968 9.54479 -0.33564 -15.5889 9.3319 +623 2 16.6398 18.4357 9.88026 3.64558 8.61996 -2.27841 +624 2 16.2643 0.755347 8.72872 -0.899564 4.78829 -7.90839 +625 1 6.16924 11.6733 8.25771 14.6298 -10.0406 -3.26225 +626 2 5.33846 11.3866 8.66461 9.26092 -3.17897 1.03444 +627 2 6.69681 10.8652 8.03849 -20.9756 15.4878 5.14008 +628 1 2.79271 8.6573 0.35403 -23.76 -9.02274 -22.2632 +629 2 2.25448 8.23641 18.2541 16.977 17.0562 34.1458 +630 2 2.21462 9.29512 0.821612 5.57875 -9.71134 -10.0126 +631 1 10.106 10.3292 6.60358 -3.61165 1.9136 -10.2284 +632 2 10.6792 9.71276 7.06962 0.244318 -4.43661 2.14915 +633 2 10.3272 10.2595 5.65755 0.987804 2.37269 11.054 +634 1 6.86896 15.7547 6.74185 -9.45188 0.350857 10.5778 +635 2 7.01957 16.2495 7.56813 1.20841 -3.75655 -8.95365 +636 2 6.86937 16.4078 6.03145 5.97827 -1.66506 -1.56051 +637 1 6.52554 12.9289 5.84178 -0.357514 -5.09084 -2.41361 +638 2 6.62829 13.798 6.2286 3.16894 9.75908 1.28602 +639 2 6.09212 12.3914 6.51525 3.69897 1.96572 0.733322 +640 1 16.7568 12.518 9.72465 -9.23185 -13.2632 0.47822 +641 2 16.902 11.7866 9.09243 0.130969 14.0381 8.74694 +642 2 17.3592 13.2171 9.48659 4.61146 3.47499 -3.98224 +643 1 6.24919 2.86496 2.77119 -11.0856 -12.869 -3.38869 +644 2 6.47325 3.75226 2.51474 6.07925 14.4727 -0.649249 +645 2 5.68088 2.55654 2.04869 4.52067 -4.17334 4.94091 +646 1 10.7277 3.04594 3.24275 -5.68944 3.06595 0.875255 +647 2 10.1765 3.79746 3.50451 2.82785 -3.23936 -2.03517 +648 2 10.278 2.63972 2.48897 0.815959 0.513447 0.723514 +ITEM: TIMESTEP +90 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.787 6.66827 17.9842 -16.1402 -3.16192 1.04025 +2 2 7.92621 6.66814 18.4555 15.1954 -0.455805 -12.5376 +3 2 8.71175 6.0436 17.2441 2.25338 3.19171 10.1252 +4 1 0.22099 8.38854 6.75163 1.7867 -5.58088 53.0968 +5 2 0.258391 8.22026 5.83332 5.30707 -13.3892 -38.1472 +6 2 0.61579 7.61263 7.23543 -10.6686 22.8516 -15.6901 +7 1 8.66795 0.370206 6.9239 18.6241 3.37743 -9.56875 +8 2 9.59619 0.315354 6.61478 -16.3273 1.21351 7.23111 +9 2 8.27983 1.03351 6.33448 -2.90229 -5.54848 4.92815 +10 1 6.43573 1.74596 11.7835 34.1799 -16.6044 -13.764 +11 2 5.93979 2.40996 12.1988 -27.1883 29.6469 18.8725 +12 2 5.80753 1.07598 11.5419 -8.40397 -16.9848 -5.34211 +13 1 6.95318 5.50156 2.37044 -56.4905 40.6357 15.9903 +14 2 6.31995 5.85318 3.09808 38.0444 -22.8427 -29.8317 +15 2 6.63738 6.03683 1.59693 20.7004 -19.4106 17.4304 +16 1 16.2563 10.1963 16.0713 -10.5934 -3.27458 3.94447 +17 2 16.9716 10.3961 15.4827 15.3322 4.9096 -4.70747 +18 2 15.8903 11.0434 16.3496 -2.84586 0.096923 -3.72852 +19 1 10.8156 14.9572 2.29652 -13.5477 -14.1276 -10.2117 +20 2 10.6343 14.4303 3.07787 2.79926 -3.05354 4.26547 +21 2 11.1766 15.7627 2.6355 11.3372 16.7492 6.7502 +22 1 17.2002 8.21443 10.9436 15.2126 5.40823 -8.20499 +23 2 16.6458 8.84622 11.4125 -4.33506 2.62691 -0.328418 +24 2 17.9515 8.74734 10.6145 -8.68143 -7.05886 2.54317 +25 1 14.6067 16.0259 16.3377 27.3765 -5.03456 2.51249 +26 2 13.6996 16.2768 16.4047 -22.3019 9.86517 -5.17321 +27 2 14.7963 15.6285 17.196 -1.96556 -8.36093 -2.03831 +28 1 12.1458 13.2907 0.563101 15.519 -14.4585 7.5186 +29 2 11.8598 13.3671 18.2945 -8.9445 7.51312 -6.12139 +30 2 11.6592 13.8773 1.15113 -3.3891 6.78651 -5.827 +31 1 9.32161 5.49231 3.86239 -40.7454 -0.097831 27.7 +32 2 8.82419 5.45502 4.73277 24.2157 -2.28744 -25.4595 +33 2 8.56838 5.45751 3.23664 18.1191 1.43276 -0.568008 +34 1 1.5546 3.92475 11.5547 -2.15894 45.2634 -4.40984 +35 2 1.55046 4.88574 11.8201 -3.55694 -26.3933 -6.97822 +36 2 1.92957 3.45678 12.2837 10.4321 -13.9157 16.7147 +37 1 2.10319 6.96614 8.15085 -9.44208 -8.37285 -17.308 +38 2 2.4095 7.43328 8.92365 8.57391 0.445975 10.2393 +39 2 2.10294 6.01871 8.3456 1.70875 2.69997 7.84786 +40 1 5.23855 4.482 7.82422 -14.5525 -1.69806 -15.7353 +41 2 5.37847 3.52895 7.72628 3.24739 1.15002 6.52498 +42 2 4.55634 4.7134 7.1559 12.5144 1.33119 10.811 +43 1 3.38552 2.88255 17.3879 -7.38377 33.0145 14.859 +44 2 4.08387 3.35622 16.9066 -6.09174 -4.5148 -0.339366 +45 2 2.81217 3.57956 17.8286 22.0641 -22.8641 -14.398 +46 1 7.5324 5.43864 6.19559 -6.90202 6.90038 35.1799 +47 2 8.08818 5.95892 6.84983 -22.5477 -17.4794 -25.4925 +48 2 6.78022 5.04202 6.71812 26.5249 9.35209 -13.645 +49 1 9.82024 7.03039 12.0775 19.8901 0.0780072 21.9724 +50 2 10.117 6.21395 11.6931 4.07542 -9.22938 -4.80372 +51 2 9.09589 7.30435 11.5485 -23.243 9.22364 -20.0663 +52 1 13.9806 3.7694 8.09667 -19.6388 4.31534 -31.7671 +53 2 13.3819 4.49155 7.81719 15.167 -9.87345 1.12215 +54 2 14.3046 4.00637 8.94223 9.52837 8.93591 30.7953 +55 1 4.52742 17.134 3.88467 -0.450754 13.2049 4.39156 +56 2 5.37483 17.5703 4.13521 -18.32 -2.84079 -10.9512 +57 2 3.94957 17.708 3.32475 23.4139 -10.9615 8.41036 +58 1 16.2726 16.5634 10.552 38.1711 -6.17539 -26.5181 +59 2 15.4837 16.6086 11.0514 -31.396 0.528555 16.213 +60 2 16.0986 15.9648 9.80419 -5.24542 6.81385 7.69127 +61 1 1.94125 4.78402 0.0638345 24.0582 25.3647 11.1071 +62 2 2.62474 5.1599 0.67023 -17.1428 -14.5257 -4.57865 +63 2 1.76164 5.54704 18.141 -7.28608 -7.40463 -3.41134 +64 1 11.2518 13.2771 16.4354 2.60185 -12.9515 -12.3757 +65 2 10.6918 12.4717 16.5304 19.7397 14.6013 -5.52798 +66 2 11.8919 13.1107 15.7025 -16.8897 -0.368153 14.685 +67 1 10.0575 10.919 16.7613 6.16873 -18.0385 3.66167 +68 2 10.4442 10.0133 16.8612 -13.1447 30.924 -0.515142 +69 2 9.09987 10.8482 16.7186 0.711039 -4.16381 0.34444 +70 1 11.8614 17.5086 13.5019 6.48767 -7.71286 -13.5562 +71 2 12.4999 17.0938 12.8959 -9.94411 -4.10313 8.27478 +72 2 12.0757 18.4326 13.4127 -0.0140719 16.2542 2.74368 +73 1 6.39981 9.50139 12.337 -4.6648 -8.8035 -19.3883 +74 2 6.97362 9.2422 11.6012 -0.80266 1.15987 5.77958 +75 2 6.9622 9.95325 12.9581 6.38846 6.66359 6.95977 +76 1 16.2975 12.8974 2.78222 -12.345 -27.8929 4.9875 +77 2 17.1496 13.2141 2.51749 15.349 9.48057 -2.38836 +78 2 15.7502 13.672 2.87844 -10.3717 9.81447 0.854078 +79 1 0.774 12.7819 5.86324 -32.223 -2.64552 -12.7856 +80 2 1.10971 12.9185 4.95432 -4.25214 -7.81578 11.8108 +81 2 18.4306 12.6074 5.76822 36.341 8.50215 1.05579 +82 1 5.29891 16.3721 18.4261 6.47 -16.9938 9.7884 +83 2 5.51669 15.4746 18.1046 -4.53971 18.6444 -2.10572 +84 2 5.85038 16.4657 0.570301 -5.83847 6.29943 -2.02707 +85 1 0.695227 7.70772 4.16735 36.5725 18.4792 -22.7587 +86 2 0.10368 7.96447 3.43723 6.76909 -3.37176 10.733 +87 2 1.60166 8.10351 3.91123 -45.3891 -20.8895 14.9183 +88 1 3.19365 9.10151 6.50287 -37.0597 -13.4257 3.63648 +89 2 3.6513 8.68447 7.23829 0.216969 0.250287 -1.31356 +90 2 2.24726 8.75126 6.54108 37.1121 17.8096 0.286984 +91 1 7.35199 10.4473 16.1779 -19.0362 -10.3824 27.97 +92 2 6.56517 10.9544 15.9216 9.49501 -5.7134 5.26362 +93 2 7.13832 10.0279 17.0488 0.309364 15.3336 -19.7914 +94 1 11.0163 0.890853 5.00632 -3.98909 -12.3472 3.8442 +95 2 10.8807 1.76939 4.61668 6.53092 -8.55309 -4.92776 +96 2 10.738 0.225438 4.34173 2.35985 18.608 2.04389 +97 1 4.21667 2.95093 13.149 10.2014 -19.1015 31.4776 +98 2 4.53515 3.41914 13.9504 -8.71013 -4.86526 -13.316 +99 2 4.15898 1.99936 13.4513 -0.534052 25.4454 -15.6313 +100 1 8.50322 10.2612 1.79208 -4.34668 -17.3092 21.2914 +101 2 8.27549 10.8526 2.5321 5.30441 -1.44182 -6.44774 +102 2 8.58493 9.36982 2.21324 2.85947 21.4101 -9.02924 +103 1 10.3161 1.69184 15.4745 -6.1912 0.342966 -7.58309 +104 2 11.1781 1.38278 15.7166 17.9205 -0.758309 5.87707 +105 2 10.347 1.84648 14.5196 -5.50104 2.18071 3.0962 +106 1 2.60936 12.9662 7.92592 -2.1007 2.96569 -8.82009 +107 2 3.10883 13.7131 7.55922 1.74385 -4.33572 0.675454 +108 2 1.96491 12.7329 7.23617 6.25685 -1.04193 4.90183 +109 1 3.83706 11.6816 4.96058 -22.5573 -14.4893 8.95363 +110 2 3.56827 11.1846 5.76493 10.0033 8.11351 -16.9036 +111 2 3.08816 11.5736 4.33469 10.7007 11.5305 11.906 +112 1 6.6582 14.5337 16.9912 3.19916 -10.5164 -7.18554 +113 2 7.36558 15.1576 17.1605 2.12516 -0.469731 1.77687 +114 2 6.47854 14.5937 16.0445 -2.82585 4.49818 1.60201 +115 1 14.2037 14.4903 3.21857 16.956 -7.57282 -16.8086 +116 2 13.9492 15.374 3.44691 -9.21692 15.261 -0.929302 +117 2 13.8764 13.9351 3.91269 -8.69982 -10.6193 13.7942 +118 1 8.69855 18.0357 16.1264 41.5507 -6.08144 10.5978 +119 2 9.33855 17.4056 16.5195 -30.3672 -5.67283 -6.86348 +120 2 9.34419 0.0405339 15.8183 -19.2067 16.0047 -5.03817 +121 1 4.69307 1.79842 4.89677 16.2385 30.5389 -26.6001 +122 2 3.80396 2.19318 4.80489 14.8244 -2.46841 6.40587 +123 2 5.29999 2.32882 4.27745 -28.5893 -25.5208 24.7929 +124 1 15.0277 12.5795 16.5521 32.6678 1.07726 26.51 +125 2 14.723 12.7481 17.4682 -6.07814 3.10734 -21.8061 +126 2 14.3421 12.5499 15.8992 -22.7964 0.862239 -7.92322 +127 1 15.7044 18.5089 16.8468 26.9219 -3.0014 45.6431 +128 2 16.268 18.6119 17.6883 -20.0241 -2.05323 -42.0683 +129 2 15.5234 17.5608 16.7959 -6.5303 3.1055 -1.70461 +130 1 1.37672 1.34924 16.652 -10.0314 2.12664 3.94932 +131 2 2.13238 1.94076 16.8287 -14.5592 -12.7899 -0.0819953 +132 2 0.657997 1.59844 17.2733 17.8805 -0.89879 -9.33461 +133 1 18.2331 4.34642 15.9005 -0.884234 -3.04582 -21.1642 +134 2 17.8346 3.73179 15.2509 9.01129 10.3034 11.7071 +135 2 0.449037 4.61451 15.5361 -9.49368 -5.77709 6.1071 +136 1 12.1007 17.0847 16.1341 -21.8736 -13.8645 50.4236 +137 2 11.3773 16.6353 16.6829 29.7152 15.2039 -30.2146 +138 2 11.8045 17.1565 15.2358 -4.92233 -3.24187 -16.5992 +139 1 16.1203 2.66556 18.245 -33.6191 11.8512 -24.8852 +140 2 15.5683 3.39571 18.6154 19.5646 -10.4389 -9.45588 +141 2 15.8602 2.60471 17.2935 4.4965 0.524143 22.3318 +142 1 6.68711 13.7575 10.0686 6.57394 0.780895 15.4701 +143 2 6.65896 13.3749 10.963 -3.37269 2.77311 -6.77332 +144 2 6.71723 13.0193 9.46247 -3.0919 -8.05072 -6.49535 +145 1 10.1832 18.4638 2.68288 15.4984 11.1175 -14.1442 +146 2 10.4797 0.410785 1.94548 -7.56539 -13.8801 19.3089 +147 2 9.29042 18.2071 2.48382 -12.5464 -2.66261 -5.58966 +148 1 3.06565 17.654 6.19973 -11.4817 2.82915 -15.5316 +149 2 2.17867 17.6912 5.79869 7.15707 -3.68965 15.0105 +150 2 3.60434 17.7569 5.40979 11.429 -4.57556 5.13078 +151 1 12.6359 16.7831 7.87678 -34.4323 5.42099 5.88286 +152 2 11.8215 16.2589 7.70694 19.4452 0.972157 -0.554869 +153 2 12.3283 17.4377 8.53506 12.9634 -4.48143 -6.06952 +154 1 14.8812 15.2555 8.26349 -9.13488 6.23831 13.721 +155 2 14.2179 15.9485 8.09528 6.25869 -7.42326 0.874894 +156 2 15.4123 15.1764 7.46942 0.572987 8.13089 -2.89012 +157 1 17.8363 18.2748 0.235726 -36.9104 2.14965 -2.72595 +158 2 18.5544 17.6878 0.132306 25.4932 -25.6882 -8.95291 +159 2 18.2375 0.371142 0.648791 5.78715 27.9621 12.2792 +160 1 0.76648 10.5228 1.42349 -23.6052 -44.6853 36.9297 +161 2 -0.0625164 10.0248 1.72181 36.7073 15.4552 -13.6362 +162 2 0.483164 11.1861 0.82966 -10.4498 25.872 -24.2739 +163 1 1.81496 12.3027 3.28068 4.06427 7.40541 18.1542 +164 2 1.38036 11.6556 2.74613 -8.62838 -16.0879 -14.4133 +165 2 2.12935 12.9782 2.6808 0.203437 6.54347 -1.70293 +166 1 0.715096 17.2857 4.99328 6.02973 16.9927 -22.851 +167 2 -0.0549074 17.8034 5.17132 -8.63108 24.1627 -3.07112 +168 2 0.561936 16.5317 5.51148 1.70853 -39.3498 23.4345 +169 1 1.0126 0.815092 9.34853 9.77893 1.05612 10.9097 +170 2 1.24172 0.537916 10.2451 4.93082 3.28815 4.21298 +171 2 0.133534 0.483606 9.24599 -18.3012 -2.93221 -7.23643 +172 1 16.7899 2.36695 13.4143 1.34336 11.0529 -24.546 +173 2 16.9036 2.71504 12.491 -0.235106 -7.90147 26.8103 +174 2 16.4417 1.47344 13.309 3.25474 -1.82726 5.59598 +175 1 2.66167 16.0077 12.0598 12.6303 -22.6944 6.71055 +176 2 3.01062 15.6298 12.8947 -8.01809 9.38789 -15.4913 +177 2 3.11281 15.5097 11.3415 -7.7677 12.8204 10.8964 +178 1 16.364 15.512 6.14932 19.0855 9.58845 -19.9598 +179 2 17.3177 15.4404 6.40388 -23.0707 9.20906 -7.80583 +180 2 16.2465 16.2844 5.52559 8.28806 -24.9431 19.8586 +181 1 5.77951 5.20043 11.8033 8.47507 -20.9263 -15.707 +182 2 5.6405 6.00993 12.2754 -6.27864 14.793 10.9641 +183 2 5.18835 4.5564 12.2066 -2.11002 -1.11499 -2.91817 +184 1 15.1794 4.92089 0.775894 -18.0102 -8.76269 31.4284 +185 2 14.9497 4.67568 1.72392 8.26683 8.97624 -32.6089 +186 2 14.3636 5.23769 0.366515 4.70525 -0.664057 3.69432 +187 1 16.3975 16.4382 1.83859 15.8969 -1.83249 -31.9545 +188 2 16.3175 16.7184 2.73629 -8.02889 11.6848 21.5541 +189 2 16.8259 17.1655 1.34034 -8.03244 -7.80667 10.4102 +190 1 0.153841 4.83744 3.963 18.3567 41.8245 -8.83163 +191 2 0.481764 5.78512 3.86014 -17.0028 -34.1388 7.97498 +192 2 0.952119 4.32423 4.11352 -0.77715 -2.59924 4.82879 +193 1 2.94647 15.0748 15.1079 -17.5423 -9.74792 39.2804 +194 2 2.84668 14.6538 16.0052 7.88621 4.55617 -28.9019 +195 2 2.37581 15.8415 15.2342 5.36547 9.02165 -11.4736 +196 1 1.04118 14.6398 9.41517 21.0794 -20.4815 -17.0137 +197 2 1.63478 13.9208 9.06194 -19.3512 25.5288 8.96267 +198 2 0.7851 14.3144 10.2695 -7.28135 -4.68142 11.1743 +199 1 13.5343 16.512 11.5541 0.415781 17.9887 -13.1724 +200 2 13.2087 17.3014 11.0493 5.42519 -19.6136 10.4452 +201 2 13.1525 15.7431 11.1062 -5.37134 4.1326 5.42785 +202 1 4.79073 1.57335 0.678685 -10.2425 -16.6589 -0.602312 +203 2 4.2243 2.02466 0.0269211 5.06007 -3.50169 9.95598 +204 2 4.26355 0.829094 1.04695 5.40097 16.8315 -2.73739 +205 1 1.55169 18.6011 11.9401 -14.2618 14.3088 -13.4455 +206 2 1.54559 0.423493 12.7773 -0.760074 5.21042 2.72529 +207 2 2.10509 17.8447 12.0596 11.7149 -17.0814 4.30068 +208 1 11.3926 10.0859 4.15406 35.1149 20.4659 -18.5884 +209 2 11.4922 10.6036 3.30306 -8.07316 -21.3073 26.3838 +210 2 12.3257 9.94393 4.45754 -25.8381 1.71308 -8.95455 +211 1 8.18732 12.2257 3.75704 -12.727 -0.351394 27.2441 +212 2 9.08394 12.5468 4.00553 -19.5779 -3.96369 2.83586 +213 2 7.55786 12.2705 4.55735 35.1927 2.13842 -31.3906 +214 1 14.6183 4.0143 3.36201 13.432 11.2186 16.7224 +215 2 15.2472 4.27703 4.07585 -12.4329 -9.47893 -15.9273 +216 2 13.7521 4.30159 3.67007 -0.91716 0.860244 -2.07153 +217 1 5.73358 1.67843 7.60794 -24.3615 -22.8066 38.6551 +218 2 5.03202 1.06037 7.9982 26.7251 29.011 -15.8684 +219 2 5.4689 1.83957 6.71483 -6.40801 -4.86943 -26.9957 +220 1 17.8709 0.966847 4.84319 9.19834 18.9135 -13.8104 +221 2 18.365 1.30942 4.06688 -7.16187 -11.4028 13.2983 +222 2 17.8528 1.72071 5.45189 -4.56365 -9.98849 0.137087 +223 1 6.8232 9.21412 4.53503 0.0591715 -6.07859 -16.7729 +224 2 6.61803 9.33533 5.45725 2.71524 4.28405 13.1117 +225 2 7.76963 9.02928 4.48077 0.0640272 -1.66157 1.55662 +226 1 2.43776 14.707 2.05519 12.3789 -12.7502 -17.0618 +227 2 3.26162 14.6424 2.56361 -5.44595 2.48516 -0.426941 +228 2 2.66563 14.4192 1.14611 -3.66427 9.22898 15.3942 +229 1 17.2291 12.9271 13.0675 -25.7945 34.5425 2.40746 +230 2 16.3582 13.328 13.3279 21.6203 -16.0155 -5.62376 +231 2 17.7378 13.7209 12.8173 -0.837652 -12.191 -0.563337 +232 1 14.8245 10.5613 1.47762 -19.5687 -28.1113 -12.7998 +233 2 15.3117 11.2776 1.82539 19.2978 30.1093 14.6064 +234 2 13.9052 10.723 1.70642 0.475408 2.13461 -1.67485 +235 1 5.64982 6.63563 4.55084 7.38671 -15.2963 15.0755 +236 2 5.89214 7.54949 4.44479 2.16454 16.7651 -4.4857 +237 2 6.3044 6.30345 5.19757 -6.24708 1.07556 -9.93912 +238 1 8.10845 8.3271 10.3627 -2.57156 5.78827 13.3728 +239 2 8.61892 8.85799 9.7482 5.06505 3.86155 0.738683 +240 2 7.30116 8.09886 9.91192 -6.7312 -10.1116 -10.9746 +241 1 13.4488 18.4608 5.65963 -13.3307 -19.6223 8.99938 +242 2 12.6096 0.239632 5.39678 7.81848 3.10411 6.37483 +243 2 13.1935 17.7385 6.2846 5.11891 19.4349 -8.45882 +244 1 -0.00278136 2.5625 0.408955 -12.183 35.1922 -19.112 +245 2 17.7147 2.60224 18.7259 18.9642 -9.11891 12.7486 +246 2 0.290302 3.48872 0.227759 6.22068 -26.2608 7.60118 +247 1 12.9842 10.8497 9.70117 -72.6257 27.1129 -13.2266 +248 2 11.97 10.965 9.69449 48.4921 6.31007 0.109369 +249 2 13.0048 9.91956 9.83068 16.3628 -25.292 6.36111 +250 1 0.548273 12.2593 11.2103 29.2233 3.63314 -8.31727 +251 2 18.2651 12.1894 11.4198 -11.8267 3.42799 7.99272 +252 2 1.06577 12.5175 11.9926 -12.6507 -2.71608 -2.06856 +253 1 5.24515 7.35168 13.3154 -11.9716 -5.94003 -7.6844 +254 2 5.73604 8.07931 12.9223 2.64227 5.43904 4.60776 +255 2 5.63818 7.16239 14.1672 7.7875 0.124539 4.29694 +256 1 1.16856 6.76355 12.0035 -37.5881 -40.6251 -19.8542 +257 2 0.334741 7.08942 11.6206 8.86965 -4.87383 5.4559 +258 2 1.63397 7.52151 12.2381 28.649 45.7996 14.9133 +259 1 15.5501 9.75639 12.3967 -1.92883 21.1886 15.8166 +260 2 15.1116 10.6344 12.221 21.3449 -31.3991 6.12972 +261 2 16.0605 9.85526 13.2245 -13.7753 0.465455 -14.4819 +262 1 16.5858 12.6354 5.59083 -2.62715 14.8355 -19.0185 +263 2 16.4437 13.5882 5.83081 0.436603 -22.1434 -16.2318 +264 2 16.416 12.5171 4.60718 5.48378 12.0784 33.3147 +265 1 6.40279 9.86277 0.0794915 -20.3924 -8.41649 -9.56759 +266 2 5.55524 10.218 0.380594 4.23452 2.32222 -1.66862 +267 2 7.0555 10.2042 0.674211 16.128 4.48978 14.4774 +268 1 12.2427 6.01171 4.00399 -23.1281 -36.6346 24.2315 +269 2 12.2798 6.64894 3.31747 0.117026 23.2517 -16.0656 +270 2 11.2984 5.74139 4.08171 19.6095 7.84283 -4.73597 +271 1 0.360057 12.9056 0.031807 -8.11921 2.1908 5.08387 +272 2 18.8977 13.4796 0.805411 -3.72305 -1.59029 -3.55744 +273 2 18.3786 13.2516 18.0169 7.85083 -4.92073 3.80969 +274 1 3.55677 18.7152 8.66247 19.9063 -6.335 -5.44295 +275 2 3.49677 18.1902 7.8473 -5.97778 6.84736 4.02201 +276 2 2.66917 0.348355 8.87781 -8.06089 0.921211 -3.36616 +277 1 7.26214 17.4262 4.43744 19.2672 26.0801 -3.30237 +278 2 7.75433 18.2474 4.74147 -22.4281 -27.0983 -14.818 +279 2 7.37471 17.3728 3.46226 -1.25032 2.03681 18.5343 +280 1 9.25258 17.1703 12.1759 28.8617 -14.1678 9.07352 +281 2 9.26958 16.3393 11.6513 -2.57153 16.4076 7.11435 +282 2 10.1283 17.1978 12.6604 -29.6357 0.448077 -14.593 +283 1 13.2677 13.193 7.99719 -21.1722 -32.5843 10.0566 +284 2 13.3388 12.6042 8.77917 0.104276 5.764 -17.169 +285 2 13.8077 13.9427 8.17139 23.4211 18.1414 5.93605 +286 1 14.7593 2.91325 15.4943 24.3728 -2.49696 -23.5999 +287 2 14.0361 2.3713 15.1546 2.238 -3.60609 4.01929 +288 2 15.4274 2.94021 14.7667 -15.6113 -2.56038 15.0831 +289 1 9.9738 15.6484 16.9671 -8.54083 0.59912 -5.05632 +290 2 10.1057 14.7848 16.5569 10.1368 1.85589 1.18764 +291 2 9.46144 15.457 17.7506 -1.80616 -1.66933 10.9911 +292 1 11.2344 8.55758 16.6355 7.77426 1.92795 -6.45244 +293 2 10.4646 8.11257 16.295 -8.96701 -9.58703 -5.10609 +294 2 11.6991 7.91388 17.1598 3.61158 -8.68538 8.99751 +295 1 4.14955 18.3179 16.8036 -6.71252 9.00681 -6.36217 +296 2 4.47312 17.6803 17.4466 6.33314 0.74429 2.85153 +297 2 4.24503 0.569095 17.1648 -0.42517 -11.8307 0.148866 +298 1 2.33957 4.29184 8.91302 22.2448 -7.34702 27.8454 +299 2 3.30686 4.08394 8.81247 -29.123 7.66299 4.05924 +300 2 2.12598 4.16624 9.8839 8.54186 0.354435 -34.7065 +301 1 9.95255 10.4179 9.8571 -18.8164 27.0404 -12.2944 +302 2 9.4534 11.1894 9.4744 17.3372 -21.5482 9.10503 +303 2 9.8309 10.4683 10.8129 6.92766 -2.76642 -0.156957 +304 1 9.80127 0.922938 10.8108 4.3272 3.59983 6.04006 +305 2 9.35046 0.175669 11.2139 0.840012 -6.18623 1.13214 +306 2 9.1369 1.38463 10.2905 0.460774 -0.831922 -5.90435 +307 1 9.16459 15.1765 10.2101 -26.8722 -7.06493 -21.2153 +308 2 8.97785 15.8968 9.57551 3.0406 -6.31351 13.2231 +309 2 8.39419 14.5643 10.0571 23.5779 16.7742 11.4525 +310 1 0.773683 9.7544 10.1833 18.261 11.1305 -23.2394 +311 2 0.868202 10.7262 10.3345 -3.82315 -24.612 -0.100636 +312 2 1.30536 9.53677 9.37727 -17.4146 8.84667 24.1623 +313 1 17.2096 4.87642 8.04469 -12.9959 -9.21067 35.1395 +314 2 16.3347 5.16277 8.3943 19.7751 -0.094318 -9.55648 +315 2 17.6197 4.3572 8.78272 -10.3132 11.9302 -24.4143 +316 1 14.8095 14.6496 0.0373288 -5.69372 -9.04424 21.9283 +317 2 15.5101 14.9524 0.640087 -10.906 0.748239 -2.66247 +318 2 14.0769 14.3265 0.613297 14.425 8.36295 -12.6903 +319 1 3.89537 11.0996 9.55593 -9.82967 16.3938 -0.398364 +320 2 3.93242 11.2996 10.5001 -1.21387 -1.78602 1.5381 +321 2 3.39392 11.8407 9.15947 5.2768 -13.1919 0.569667 +322 1 11.4169 10.7371 1.49225 5.47317 24.4145 -6.81884 +323 2 11.5532 11.6314 1.08329 0.074839 -23.6179 10.2373 +324 2 10.4618 10.6109 1.50924 -1.9569 -1.96948 -2.8184 +325 1 13.1395 7.21524 12.5729 -20.455 -7.16835 0.858137 +326 2 14.0577 7.03675 12.4308 23.1896 -1.74136 0.0778831 +327 2 12.7378 6.3322 12.608 -1.47964 6.92135 2.9072 +328 1 9.65614 1.96645 0.86496 18.1931 4.09637 20.8777 +329 2 8.84682 1.67677 0.484793 -23.8326 -3.90796 -8.97572 +330 2 10.1746 2.31935 0.150168 8.91513 5.01659 -9.40528 +331 1 10.6386 13.4197 4.53193 2.28663 -4.65747 18.8344 +332 2 11.4948 12.9639 4.69275 -16.1918 12.7288 -0.469196 +333 2 10.3958 13.8423 5.38242 9.30576 -5.17735 -13.1714 +334 1 14.5273 1.57884 10.9459 15.1221 22.4117 -0.776229 +335 2 15.362 1.31139 10.5257 -10.7732 -5.17355 3.70166 +336 2 14.6474 2.54531 11.0746 -6.11584 -12.5888 -6.32845 +337 1 14.4766 12.0159 11.6273 -10.9263 4.56586 -44.1867 +338 2 15.2047 12.4077 11.0864 -12.0042 -9.95663 15.0185 +339 2 13.8634 11.5981 10.9451 22.3117 17.3775 30.6101 +340 1 8.16847 5.14124 9.81669 -29.5484 17.7318 23.7918 +341 2 7.27475 5.12719 10.2684 30.6512 -1.40914 -16.6308 +342 2 8.33799 4.26267 9.50012 -3.06916 -18.2431 -3.24008 +343 1 1.5108 16.9662 18.5044 9.55151 26.7901 -23.2493 +344 2 1.84435 17.2897 17.6363 -7.76754 -5.77411 19.656 +345 2 1.83481 16.0826 18.5596 5.96378 -22.3257 1.76596 +346 1 1.42717 17.3886 15.3379 47.0554 -13.0927 -7.45492 +347 2 1.50543 18.1882 15.8264 3.14075 27.3625 12.617 +348 2 0.523906 17.2066 15.2924 -49.7083 -12.5335 -2.74225 +349 1 3.49173 5.73723 6.04987 -5.63889 12.5308 6.32322 +350 2 3.05134 6.46754 6.5425 11.5005 -15.9447 -9.63575 +351 2 4.14223 6.14285 5.45548 -4.8412 1.1033 3.2125 +352 1 12.5916 9.51872 14.2408 10.4293 -27.0271 -12.8548 +353 2 13.028 8.79356 13.6831 -19.628 26.0366 30.4849 +354 2 12.3513 9.14884 15.1174 6.55215 0.813797 -17.5332 +355 1 4.09544 15.2089 7.12218 31.8609 13.6269 2.32941 +356 2 3.67616 16.0257 6.80924 -1.84113 -5.17266 1.34804 +357 2 5.07546 15.4284 7.13078 -32.8392 -10.6488 -3.17146 +358 1 0.799143 8.79431 15.1488 8.21516 12.8732 -16.9375 +359 2 0.575284 9.7423 15.0796 -2.5473 -12.0602 5.3867 +360 2 1.52676 8.70151 14.5038 -8.32138 -2.51513 8.31525 +361 1 12.8725 8.28632 10.0993 13.5644 -10.3417 -12.785 +362 2 13.6812 7.81606 9.78663 -13.8637 7.80766 13.5238 +363 2 12.7502 8.10095 11.0322 6.24745 -8.27276 5.3213 +364 1 15.2423 7.98405 3.44353 15.6799 19.5655 -11.9659 +365 2 14.4463 7.83544 2.89643 5.54982 -16.2362 17.4101 +366 2 15.5184 7.39607 4.17406 -22.72 2.15229 -11.0841 +367 1 17.1687 6.76019 0.0376092 -10.314 6.5713 -12.413 +368 2 16.7239 5.93548 0.292072 -0.0664332 9.88195 -1.29815 +369 2 16.4741 7.34647 18.2846 16.8516 -16.4801 16.1304 +370 1 8.96925 6.98328 7.86383 -27.8745 -15.8066 22.0328 +371 2 9.86939 7.24269 7.81058 30.3142 9.1639 -3.03437 +372 2 8.87474 6.48936 8.713 -1.39219 10.6855 -19.1169 +373 1 12.482 0.614891 1.23015 1.92335 -8.70167 1.10105 +374 2 13.2432 1.03802 1.64803 2.06157 -2.24376 -3.30204 +375 2 12.803 0.16068 0.442821 -0.913907 6.47573 3.0001 +376 1 5.66871 15.0647 14.4598 7.14191 19.2454 -5.51099 +377 2 4.75956 15.0903 14.7907 1.11348 4.01334 -3.77227 +378 2 5.94804 16.0038 14.294 -6.0872 -24.4911 3.70117 +379 1 3.73529 6.48244 1.70347 -4.32476 7.10488 -19.4811 +380 2 3.3805 7.26573 1.22404 3.0021 -10.505 14.7125 +381 2 3.73285 6.71028 2.6365 -0.71904 4.06656 1.73817 +382 1 3.86925 11.322 12.3296 2.55777 5.65869 0.326193 +383 2 4.7048 11.7602 12.5386 0.0734552 -4.93202 -1.70743 +384 2 3.20028 11.8652 12.7549 -2.96009 3.18005 0.676376 +385 1 5.3196 3.88545 15.7107 -12.565 72.4648 14.1271 +386 2 6.00107 3.31 15.4478 35.5939 -28.3589 -8.92722 +387 2 5.74724 4.80358 15.8116 -17.6513 -43.1362 -7.7855 +388 1 14.0258 10.1309 4.70784 36.378 -19.982 -23.5474 +389 2 14.2654 9.87929 5.60631 -3.02994 -1.07275 0.485782 +390 2 14.6765 9.60938 4.12831 -34.5421 20.7478 23.7761 +391 1 7.50853 17.298 8.98976 4.28677 22.6193 13.4416 +392 2 7.01472 17.6504 9.76182 0.935323 -12.9311 -15.6818 +393 2 7.87431 18.0869 8.55212 -1.49272 -9.54271 -2.09709 +394 1 4.57424 14.4015 3.77738 -1.32578 6.84514 50.6918 +395 2 4.51443 15.3073 4.2079 4.46262 -31.6709 -20.6737 +396 2 4.58351 13.7394 4.53798 -1.39317 23.0513 -31.5206 +397 1 14.2431 7.32994 15.8885 26.8814 9.55229 5.02737 +398 2 15.048 7.31796 15.3145 -19.1816 0.583054 17.9404 +399 2 14.5184 7.8184 16.7026 -8.00009 -12.2304 -19.9762 +400 1 3.00564 18.4171 1.98737 1.19435 35.3283 33.2576 +401 2 2.60973 17.9491 1.28647 -18.7059 -24.7202 -27.1582 +402 2 2.28625 0.311703 2.39571 15.2164 -11.2621 -13.5372 +403 1 7.97098 1.60459 4.54116 29.2267 3.13781 -13.0843 +404 2 7.39603 1.96083 3.86318 -8.15365 2.40339 -0.697123 +405 2 8.86388 1.74438 4.1564 -17.9094 -5.03071 12.9608 +406 1 2.50155 14.1648 17.7228 -14.4362 -20.2086 14.4505 +407 2 1.80023 13.5192 18.0233 22.5798 22.6486 -13.5864 +408 2 3.34474 13.7188 17.8802 2.38023 -0.79805 1.89101 +409 1 0.962462 1.97628 13.8796 24.0866 5.42438 -18.2963 +410 2 1.23331 1.73159 14.7528 2.00372 -3.67266 20.967 +411 2 0.0219615 1.96156 13.879 -26.3344 -0.788872 -2.58417 +412 1 4.34962 0.156713 13.8729 25.4477 -1.51409 -1.97896 +413 2 5.30295 18.5478 13.9084 -21.2168 3.6137 -4.76321 +414 2 3.99528 18.4902 14.7051 -3.29088 -0.042535 8.53213 +415 1 7.35889 1.01117 18.4602 -20.0845 2.29217 31.534 +416 2 7.53777 0.614221 17.6282 1.02155 -13.8743 -28.1328 +417 2 6.39885 0.929085 18.6632 17.4429 7.83311 -8.37388 +418 1 15.8463 18.3909 13.9448 -43.3072 10.6601 -1.92517 +419 2 14.916 18.6906 13.7723 29.0574 -10.6436 -1.66619 +420 2 15.8257 -0.445507 14.8871 10.2412 6.45473 0.424587 +421 1 10.2808 4.63783 16.2194 -42.4572 -26.934 -19.6441 +422 2 11.2059 4.65809 16.3645 33.0638 0.71496 4.62375 +423 2 10.0964 3.70704 15.9214 4.59595 26.5122 11.6188 +424 1 15.903 17.6519 4.47823 -22.6026 32.3058 18.5214 +425 2 16.5145 18.4189 4.46111 -7.58873 -12.9749 2.84853 +426 2 15.0701 18.0221 4.91498 30.26 -18.095 -22.6862 +427 1 6.91987 17.5654 13.9309 41.5981 2.12242 13.325 +428 2 7.49428 17.7119 14.7497 -22.2257 -6.74767 -31.4029 +429 2 7.56851 17.4237 13.1898 -17.2813 4.26485 21.283 +430 1 13.2143 6.40362 6.52296 -17.8609 -7.45559 2.6451 +431 2 14.0836 6.75111 6.37132 17.2928 3.48546 -1.85822 +432 2 12.8363 6.25317 5.64277 2.90235 4.29902 5.97585 +433 1 7.86013 2.26394 9.49062 -8.36252 -9.46169 -35.4407 +434 2 7.29684 2.1706 10.2513 -11.7917 -0.851936 13.7299 +435 2 7.34714 1.87564 8.72892 15.7155 15.0955 20.8405 +436 1 15.1343 14.8378 13.7575 -15.8142 13.0315 4.83039 +437 2 14.8532 15.0481 14.6708 3.35379 -3.45087 -12.098 +438 2 14.5629 15.3828 13.1802 11.493 -9.40285 7.27009 +439 1 9.38118 8.39884 3.83519 4.0123 -7.74443 -2.87465 +440 2 10.2467 8.83344 3.97294 -13.6344 -10.1795 -2.34121 +441 2 9.51993 7.43201 3.84247 0.270426 14.3255 0.324032 +442 1 17.6982 13.5806 16.4882 -11.1823 29.4115 -15.1875 +443 2 16.7477 13.4163 16.452 -1.16521 -4.14372 2.83933 +444 2 17.7994 14.4458 16.0124 3.95943 -25.1425 10.6502 +445 1 4.93057 10.3937 2.82949 21.3493 0.31084 -7.87351 +446 2 5.82872 10.0425 3.0149 -20.5327 4.11374 3.5741 +447 2 4.70497 10.9363 3.59521 3.63155 -1.89772 -0.291932 +448 1 3.65557 8.40975 9.92882 -7.92631 -13.4411 16.4299 +449 2 3.66668 9.34394 9.72247 1.00161 8.70404 1.26029 +450 2 3.36367 8.33438 10.8592 4.36465 5.8519 -13.4993 +451 1 15.9508 6.91708 5.85912 26.4071 -7.62551 -3.83966 +452 2 16.729 7.34279 6.26867 -14.5536 -3.6129 -4.6023 +453 2 16.2929 6.05819 5.53033 -12.7649 13.2481 9.54942 +454 1 15.2478 7.26488 8.9948 -11.5397 21.0457 -23.7706 +455 2 16.0349 7.57374 9.47019 -5.83 4.16597 -2.61919 +456 2 14.9977 7.92652 8.27445 16.2337 -23.38 28.7542 +457 1 6.17715 12.7863 12.74 7.06624 23.8889 14.8517 +458 2 6.98998 12.4152 13.1111 -3.934 -5.41615 -1.6338 +459 2 6.02064 13.6181 13.2483 1.6805 -16.267 -10.1818 +460 1 12.1255 4.53395 13.1266 36.5984 28.8141 18.352 +461 2 12.1988 4.68857 14.088 4.72218 -0.985297 -9.83354 +462 2 11.344 4.04995 13.0228 -42.0246 -23.4808 -8.79261 +463 1 11.4542 8.08345 7.86287 23.2187 -10.867 14.4494 +464 2 12.2022 7.55078 7.50013 -20.6002 10.1652 -0.104446 +465 2 11.6749 8.16233 8.821 -5.77941 1.62242 -23.2927 +466 1 16.9966 10.8 7.60022 14.0465 -17.3895 -10.8701 +467 2 17.6655 10.1188 7.31004 -18.6815 22.6831 6.1404 +468 2 16.8855 11.476 6.90625 3.56282 -12.242 0.823841 +469 1 5.28409 18.0615 10.7272 -25.4136 -4.73004 -4.09376 +470 2 4.85025 17.4105 11.3211 10.0924 14.2936 -14.0097 +471 2 4.61921 18.235 10.0106 18.3134 -6.11244 18.1083 +472 1 7.63344 17.4775 1.60819 -12.3126 -2.35291 35.094 +473 2 8.06049 16.702 1.26786 10.3266 -12.472 -14.3961 +474 2 7.64482 18.174 0.971148 2.96613 14.6858 -21.2308 +475 1 1.92556 12.9088 13.6099 -6.92879 6.84011 17.0322 +476 2 1.40166 12.3078 14.1747 6.51182 9.66465 -5.96466 +477 2 2.01688 13.7519 14.1152 3.80073 -20.221 -11.3532 +478 1 9.32296 6.74742 14.7603 -6.16505 19.9578 -6.21839 +479 2 9.80961 6.04203 15.1542 10.8193 -23.4577 14.2182 +480 2 9.81429 6.97553 13.9666 -4.58884 0.0213979 -5.59057 +481 1 15.2687 4.29028 10.7744 -16.6773 -11.1812 -9.87371 +482 2 16.185 4.03181 10.6852 9.89086 1.55812 4.86514 +483 2 15.2046 4.88146 11.5266 6.28069 5.56792 1.9642 +484 1 11.3833 6.23863 0.0689293 -3.19885 -6.29427 4.65322 +485 2 11.5449 5.27036 18.7473 -10.1654 17.1623 -6.02864 +486 2 10.4171 6.41156 18.6664 16.019 -11.974 -2.10863 +487 1 18.4779 11.4738 14.9298 -4.11302 6.12113 -30.5228 +488 2 18.0937 12.0014 14.1715 8.36132 -18.8326 26.0479 +489 2 18.3027 12.0103 15.7035 0.536699 7.83234 4.13522 +490 1 7.03799 9.27423 7.33397 -11.8444 -18.9096 15.35 +491 2 6.61404 8.50211 7.787 12.2323 17.6714 -16.3801 +492 2 7.97664 9.07639 7.31215 4.33333 -2.45816 -2.54611 +493 1 18.3885 15.3347 12.1965 11.3664 3.9942 -3.56245 +494 2 0.676524 15.5664 11.9851 -14.9026 2.39255 4.26485 +495 2 17.8062 15.8491 11.6143 4.55299 -1.04774 1.98359 +496 1 16.551 4.342 5.30396 -29.3567 -2.30965 40.8017 +497 2 16.5003 4.35995 6.30392 8.99046 -4.55546 -31.3189 +498 2 17.4312 4.58446 5.06774 26.2551 1.0485 -9.7407 +499 1 17.7614 3.18175 10.7726 14.454 -1.68376 5.55906 +500 2 18.6848 3.25815 11.0867 -17.2868 6.635 -4.74284 +501 2 17.731 2.30667 10.3896 -4.78084 -7.5669 -7.23363 +502 1 12.3288 18.6185 10.0887 4.81564 48.0444 9.66027 +503 2 11.5224 0.4701 10.402 18.5752 -22.9317 -12.6203 +504 2 13.04 0.683861 10.1001 -20.831 -28.6711 -0.571217 +505 1 10.4023 9.75891 12.5069 9.56908 10.7357 22.5843 +506 2 11.0968 9.84844 13.1991 -9.82495 1.00858 -15.0243 +507 2 10.3005 8.81694 12.4067 -0.389825 -11.0581 -5.16736 +508 1 0.728244 2.62509 7.20528 10.511 21.9286 8.67284 +509 2 1.10851 3.44304 7.59367 -9.47208 -14.047 -5.98037 +510 2 0.946108 1.9669 7.86838 0.119732 -6.07738 -1.41007 +511 1 0.301432 15.3195 6.88989 15.9737 -48.0831 -14.5816 +512 2 0.502768 15.5752 7.7858 2.08568 -2.79341 12.7124 +513 2 0.620951 14.3521 6.81024 -17.8336 49.2232 -1.9498 +514 1 17.0496 6.91172 14.9593 8.8057 -4.67917 1.70395 +515 2 17.812 7.50707 14.8676 -6.01141 -3.19386 0.836122 +516 2 17.3983 6.09137 15.355 -4.50622 8.29661 -2.9861 +517 1 9.11865 12.5108 8.02933 -49.9881 -7.42173 -16.2711 +518 2 9.47674 11.8107 7.47486 8.95817 -5.21768 -2.38673 +519 2 8.15231 12.5395 7.74329 38.6911 2.79466 15.4325 +520 1 1.1334 1.67756 2.81686 3.27117 15.7614 -6.58164 +521 2 0.957986 2.31477 2.10151 -6.66947 -14.3695 3.78127 +522 2 1.78538 2.12055 3.36586 -0.578909 1.22693 6.40118 +523 1 4.20106 15.0562 10.0364 -13.4085 1.18971 -5.18923 +524 2 3.93003 15.0868 9.10675 3.70212 3.27773 4.96515 +525 2 5.05647 14.6363 10.0432 10.3336 -3.36269 -1.32379 +526 1 7.40784 2.22679 14.822 -4.38879 4.63456 3.27925 +527 2 7.05629 1.62422 14.1639 1.19517 -1.6595 -3.72526 +528 2 7.83793 2.94849 14.3413 -6.72155 -4.85002 1.32971 +529 1 18.3301 14.5327 2.1542 24.8671 -25.4621 4.78212 +530 2 0.57397 14.7195 2.50861 -8.4973 4.51839 -6.64425 +531 2 17.8578 15.3422 2.05909 -12.5294 22.9533 -1.13776 +532 1 10.0489 2.71902 12.9028 6.85621 -14.8278 -12.6664 +533 2 9.96638 2.08865 12.1549 1.47254 10.1846 11.5218 +534 2 9.24995 3.25129 12.8895 -2.74325 3.95657 -0.856162 +535 1 2.95855 8.84401 12.9769 -19.5266 -12.9618 -2.46154 +536 2 3.45638 9.64099 12.8192 4.11354 12.8609 -3.4499 +537 2 3.6113 8.17746 13.175 10.7686 -6.78904 5.39462 +538 1 3.18595 8.60313 3.78164 6.49512 -8.67182 57.5105 +539 2 3.58728 9.20701 3.1814 16.1034 15.9636 -13.6327 +540 2 3.51933 8.8716 4.70776 -18.429 -13.2453 -44.8458 +541 1 5.73851 7.25721 8.5964 -4.13987 -1.96532 11.6754 +542 2 5.69005 6.29369 8.53393 1.30439 2.87011 -1.70973 +543 2 5.04632 7.51192 9.22575 1.66035 -1.11756 -5.95213 +544 1 14.9081 1.62503 1.83745 -8.73365 -28.3512 -14.8102 +545 2 15.1675 2.29904 2.4498 2.46531 19.8996 4.15138 +546 2 15.1848 1.81402 0.924567 6.2551 4.83326 15.3454 +547 1 8.63912 15.0489 0.67096 1.85438 -3.84451 5.87273 +548 2 9.43742 14.948 1.21756 -6.6173 4.03251 -1.68679 +549 2 7.96284 14.4978 1.10066 2.22069 5.93818 -4.9944 +550 1 15.4364 1.44293 7.19944 -29.9197 -3.33934 -17.0244 +551 2 14.7125 0.994492 6.68707 24.0317 7.87524 16.0302 +552 2 15.0797 2.33705 7.33252 4.46076 -6.95989 4.74521 +553 1 4.93029 12.8913 18.4644 10.9792 1.21933 18.1223 +554 2 5.27563 12.987 0.740174 -6.01723 -1.47567 -19.726 +555 2 5.68015 13.1369 17.9044 -5.07302 3.16897 2.74711 +556 1 15.3923 8.68146 18.054 15.694 19.9465 -16.5309 +557 2 15.9315 9.21769 17.4147 -18.0717 -17.5644 15.7946 +558 2 15.1857 9.29971 0.121687 -1.56315 -2.75746 2.59172 +559 1 11.9784 3.14039 18.3403 11.1408 -7.29272 18.8649 +560 2 12.1001 2.9975 0.653392 -4.70819 -0.503108 -12.7749 +561 2 12.4778 2.40933 17.9385 -7.35096 7.48199 -3.86664 +562 1 13.1896 12.7267 5.18606 4.81883 -3.59528 0.0329893 +563 2 13.4958 11.8346 4.97314 2.3467 3.28367 -0.068752 +564 2 13.4618 12.8881 6.09814 -4.13789 -2.12194 -0.520265 +565 1 6.18108 7.13483 0.245639 -8.98659 -24.3205 -5.24363 +566 2 6.15368 8.0627 19.0493 5.02048 26.2765 -0.395042 +567 2 5.28324 6.84248 0.444666 1.40419 -2.69741 2.9636 +568 1 17.7469 15.8806 14.9091 -16.6307 4.82259 1.60218 +569 2 16.7811 16.0196 14.9781 16.1488 -1.66255 -6.01934 +570 2 17.9228 15.7652 13.9648 -0.217809 -0.705292 2.49903 +571 1 13.1074 0.925484 16.7107 3.18003 -6.63181 9.52558 +572 2 14.0398 0.701227 16.9047 -10.9319 3.14101 -7.94235 +573 2 12.6435 0.0729893 16.6565 6.11054 4.53406 -2.82687 +574 1 10.8779 14.5049 7.42771 23.1657 22.4115 -16.2389 +575 2 10.1426 13.9786 7.6854 -20.2069 -15.6201 11.4355 +576 2 11.6544 13.9411 7.50544 0.873985 -2.97227 1.69423 +577 1 17.7332 8.41688 2.16357 9.83329 25.3003 13.1733 +578 2 16.8474 8.49196 2.51389 -11.5025 -5.56634 1.51969 +579 2 17.684 7.86174 1.40275 -6.79002 -17.3841 -17.6814 +580 1 12.5241 7.78132 2.0423 -1.44154 17.0415 -14.1456 +581 2 12.3356 8.69211 1.74465 0.56853 -10.9135 10.1338 +582 2 12.0507 7.22418 1.41137 4.13261 -1.84431 -3.3422 +583 1 12.0402 14.5123 10.5082 -18.3289 -2.04433 -49.0296 +584 2 12.3885 14.3833 9.58045 -11.5085 2.39427 35.0464 +585 2 11.0712 14.6752 10.3612 24.5139 -2.29095 9.58119 +586 1 6.7433 6.75035 15.5111 8.69017 25.9379 21.8943 +587 2 7.64047 7.11596 15.2998 -22.3365 -16.355 4.27733 +588 2 6.42641 7.26782 16.2896 9.37622 -14.6905 -17.8302 +589 1 7.9604 4.42511 13.2728 28.7823 16.7879 24.018 +590 2 7.37747 4.63038 12.5661 -23.4436 4.48442 -18.6585 +591 2 8.25373 5.30295 13.5968 -1.99494 -17.578 -1.9241 +592 1 13.2943 12.2257 14.4027 3.56556 -5.33332 1.41443 +593 2 13.2861 11.2546 14.3815 -5.78887 6.10336 -0.82645 +594 2 13.6298 12.4878 13.5348 -0.194802 0.853385 3.24808 +595 1 14.4975 9.60743 7.32851 -1.81828 -22.5371 -11.9494 +596 2 15.283 10.0905 7.53237 20.8949 12.3364 4.94663 +597 2 13.7862 10.0745 7.73482 -16.3884 10.3496 13.6544 +598 1 12.6855 16.7955 3.35468 10.446 54.0378 -9.24021 +599 2 12.8247 17.4169 4.11373 -2.43161 -22.9959 -18.5255 +600 2 12.7287 17.4093 2.56008 -5.07923 -25.2307 27.5772 +601 1 0.985851 7.00227 17.3383 1.31889 9.4813 -6.51378 +602 2 0.174673 6.82729 17.8428 -2.72668 6.21708 -7.63644 +603 2 0.788987 7.63656 16.6124 1.43967 -10.9643 14.4702 +604 1 12.9703 4.85252 15.7444 36.7131 7.67865 -11.6648 +605 2 13.7444 4.28338 15.4912 -28.1266 12.6425 14.7219 +606 2 13.3848 5.73698 15.8318 -12.3641 -9.92719 -0.136909 +607 1 2.31739 3.41657 5.06312 -13.6796 12.8802 45.0615 +608 2 1.71742 3.03519 5.77756 22.5616 7.27981 -29.9715 +609 2 2.67638 4.25091 5.49055 -8.69432 -27.9074 -22.1065 +610 1 8.14626 10.9014 13.7501 23.1519 -21.2188 51.9658 +611 2 8.18961 10.6456 14.7569 -3.14293 16.1916 -66.8861 +612 2 8.91613 10.442 13.3487 -9.38929 12.2654 3.7561 +613 1 12.9965 1.57692 13.2293 -13.236 30.2614 -33.2276 +614 2 13.5053 1.61767 12.3799 -8.92772 -10.8244 27.0208 +615 2 12.3556 2.33631 13.1194 22.5086 -26.9187 11.5847 +616 1 6.63966 13.684 2.03193 -11.5531 1.65982 24.7971 +617 2 6.01437 14.0711 2.69678 13.9712 -7.1585 -19.9778 +618 2 7.21702 13.1132 2.57076 -4.92077 5.61769 -6.96253 +619 1 15.813 6.37449 12.4855 -26.0384 -19.2076 5.56376 +620 2 16.3133 6.94665 11.9354 17.458 16.492 -16.919 +621 2 16.1081 6.5465 13.3734 10.1637 1.50607 12.5345 +622 1 16.7517 0.683836 9.54032 9.17465 -17.8268 3.86543 +623 2 16.8312 18.3701 9.76674 -11.2714 16.7378 -3.92594 +624 2 16.3182 0.76443 8.67683 0.0107679 -1.03064 0.242674 +625 1 6.19528 11.6935 8.23629 -2.98771 -55.3704 13.0415 +626 2 5.39217 11.4329 8.74625 16.1659 14.5788 -12.0119 +627 2 6.59624 10.789 8.03203 -10.8651 41.6219 1.75135 +628 1 2.78257 8.63233 0.349942 -51.0927 -6.02203 -19.4773 +629 2 2.14734 8.16991 18.3384 31.254 20.3071 31.1367 +630 2 2.20011 9.24624 0.868363 16.6862 -13.9373 -14.0055 +631 1 10.0933 10.2699 6.60791 4.69659 2.91801 -6.95173 +632 2 10.6585 9.65933 7.0984 -2.33853 -1.64778 -0.152736 +633 2 10.478 10.3114 5.71024 -7.38541 0.394324 12.3102 +634 1 6.85971 15.7454 6.78123 4.24276 8.06212 3.90305 +635 2 7.14611 16.2575 7.56121 -6.95129 -7.98507 -8.49325 +636 2 7.04221 16.3283 6.02778 -2.00154 -5.2395 1.03704 +637 1 6.5672 12.9167 5.89107 0.597921 -4.77378 -3.41809 +638 2 6.75629 13.7931 6.22612 0.282518 9.70238 2.49815 +639 2 6.16516 12.4266 6.61937 1.75727 3.9196 -1.62353 +640 1 16.7395 12.5246 9.74847 -3.06854 -10.3396 -13.3378 +641 2 16.803 11.7934 9.09918 0.0574675 11.3505 13.7779 +642 2 17.2471 13.2388 9.35461 0.0307086 0.265441 4.69208 +643 1 6.27963 2.83254 2.76143 -4.73524 -28.0523 14.6006 +644 2 6.37898 3.73989 2.5277 5.16678 22.951 -10.7112 +645 2 5.79937 2.39077 2.0523 -0.657158 4.14199 -3.99187 +646 1 10.6834 2.9997 3.2493 -4.30343 6.66703 3.45031 +647 2 10.3389 3.87773 3.47337 -2.10815 -7.43082 -2.74741 +648 2 10.1644 2.67816 2.50044 1.52937 0.706493 -1.87803 +ITEM: TIMESTEP +100 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.77244 6.59569 17.9763 -3.45079 -15.6041 -9.13306 +2 2 7.88004 6.49722 18.3444 6.65526 3.83231 -3.73646 +3 2 8.88832 5.875 17.3232 0.339998 10.7344 11.2284 +4 1 0.232197 8.43163 6.74931 6.06809 -9.75314 40.4456 +5 2 0.255717 8.25928 5.82997 0.568886 -7.03857 -37.2819 +6 2 0.690537 7.6579 7.15764 -12.6716 20.3857 -3.7924 +7 1 8.73054 0.448274 6.96197 0.757688 5.19807 -2.99354 +8 2 9.64384 0.493158 6.62895 -11.5479 0.592924 -0.0248858 +9 2 8.1978 0.998025 6.35807 9.15448 -7.13553 5.61176 +10 1 6.40593 1.75267 11.8149 38.8296 -3.08614 -8.28972 +11 2 5.81968 2.38515 12.1727 -25.8813 19.5399 13.38 +12 2 5.91601 0.958217 11.6787 -14.9693 -21.4487 -5.83463 +13 1 6.93553 5.46707 2.3717 -29.4847 3.29264 10.9289 +14 2 6.2293 5.77948 3.0367 33.3819 -5.43232 -34.2308 +15 2 6.73101 5.82483 1.47662 0.276644 1.33511 28.97 +16 1 16.2706 10.1725 16.0328 16.576 -12.0275 -13.9735 +17 2 17.1689 10.3287 15.6909 -13.6837 1.56601 5.28727 +18 2 15.9002 11.0264 16.2303 -5.40144 13.1923 2.47446 +19 1 10.8573 14.9713 2.3127 -4.53536 -0.807355 -13.4682 +20 2 10.8458 14.5197 3.15612 -3.95698 -5.41896 6.20362 +21 2 11.2908 15.8056 2.48855 3.23834 4.77246 6.19277 +22 1 17.2232 8.21136 11.0033 2.73792 2.45641 -7.11401 +23 2 16.6726 8.88418 11.4331 2.86084 -2.93597 -0.581414 +24 2 17.9525 8.69866 10.5809 -6.6523 -2.55116 4.88578 +25 1 14.5937 16.0509 16.2923 16.8919 1.55785 -12.0612 +26 2 13.6919 16.3738 16.3176 -7.99874 0.738503 2.77307 +27 2 14.7362 15.4806 17.0483 -6.38665 -4.70858 10.3974 +28 1 12.1782 13.2488 0.556058 -6.41896 9.17153 -4.9038 +29 2 11.8393 13.4134 18.3136 3.64438 -6.73296 -6.87976 +30 2 11.6781 13.8768 1.08938 4.30308 -0.940018 9.70193 +31 1 9.32636 5.50189 3.85673 -23.6707 -6.9557 11.6523 +32 2 8.85207 5.35955 4.73387 10.6863 3.91607 -36.7024 +33 2 8.65492 5.41152 3.1282 11.356 3.18621 25.5004 +34 1 1.53424 3.89903 11.544 -4.66799 23.5976 14.1629 +35 2 1.33558 4.79151 11.9229 9.77101 -18.0042 -9.49869 +36 2 1.78943 3.33535 12.2834 2.68741 0.460061 1.88957 +37 1 2.11036 6.99869 8.11066 2.48315 -17.2899 2.96853 +38 2 2.57184 7.49315 8.78305 3.29023 12.1045 5.89357 +39 2 2.1177 6.10606 8.48449 -3.4025 -1.3508 -8.01694 +40 1 5.18347 4.46977 7.78792 -2.57538 4.03359 -5.12796 +41 2 5.37117 3.51932 7.65443 -4.82345 11.4027 -0.558597 +42 2 4.53495 4.79047 7.12216 11.4175 -13.4448 8.55636 +43 1 3.42716 2.88114 17.3924 1.12201 37.8538 -2.09818 +44 2 4.03218 3.21565 16.6954 -8.80258 -2.8612 13.6459 +45 2 2.96175 3.68375 17.7714 12.3959 -28.5801 -12.8282 +46 1 7.56049 5.45137 6.19682 -11.2764 11.7759 39.3451 +47 2 8.17338 6.02323 6.733 -17.9712 -15.9787 -15.2388 +48 2 6.83707 5.19934 6.84169 25.8687 -1.03041 -23.6459 +49 1 9.81873 7.03274 12.0818 18.6926 1.80354 21.1658 +50 2 10.1168 6.17447 11.801 2.37707 -8.57843 -5.75387 +51 2 9.13705 7.28384 11.4839 -21.9155 5.9942 -18.2818 +52 1 13.9782 3.81734 8.11005 -6.38125 -7.14222 -11.0636 +53 2 13.4268 4.53125 7.77431 4.97705 1.71109 -4.47031 +54 2 14.3288 4.12395 8.93436 6.50574 7.00298 17.9277 +55 1 4.54162 17.1358 3.87887 10.9044 35.7056 -0.341992 +56 2 5.36932 17.5648 4.19271 -11.2647 -17.0231 -6.60056 +57 2 4.14672 17.8103 3.27983 -0.0256371 -21.9717 9.98561 +58 1 16.2123 16.5489 10.6095 26.1835 -5.76397 -19.4616 +59 2 15.4589 16.7003 11.1416 -23.8325 7.35421 23.2226 +60 2 15.8886 15.8767 10.0022 2.98718 1.98497 -7.14015 +61 1 1.93449 4.79928 0.00082377 17.3961 -4.98991 5.57961 +62 2 2.67896 5.07161 0.592242 -22.0191 7.26131 -10.4701 +63 2 1.68005 5.53286 18.0583 5.78187 -2.17332 10.5029 +64 1 11.1761 13.3033 16.4476 20.6858 -29.5101 -20.5449 +65 2 10.7502 12.4348 16.5818 -0.505604 15.8506 2.04497 +66 2 11.8189 13.0874 15.7254 -14.483 14.0049 15.9552 +67 1 10.0082 10.9133 16.7377 -9.76065 -12.5647 6.43928 +68 2 10.4104 10.0696 17.0143 -3.0625 14.8211 -5.5238 +69 2 9.04798 10.758 16.6751 14.6534 4.77532 0.819581 +70 1 11.8926 17.5507 13.5059 -15.5524 -14.4544 -0.25773 +71 2 12.4585 17.1847 12.8152 4.41482 5.53476 3.60851 +72 2 11.9755 18.5016 13.5139 9.00416 11.9454 -7.12981 +73 1 6.39659 9.54323 12.3526 -12.6063 6.46711 4.93213 +74 2 6.97402 9.29797 11.635 9.25294 -5.21247 -6.5221 +75 2 6.9248 10.0607 12.9773 -1.49192 -5.83682 -8.37915 +76 1 16.2827 12.8664 2.8283 0.430065 -24.2056 0.300325 +77 2 17.1271 13.2094 2.55074 10.9303 3.80489 0.0707423 +78 2 15.7284 13.6342 2.87288 -15.0446 12.1841 2.12753 +79 1 0.782434 12.8185 5.85612 -33.4557 3.27495 -26.778 +80 2 1.12737 12.9122 4.94214 -3.16706 -8.15793 13.9432 +81 2 18.4302 12.7528 5.74133 33.3816 -1.67566 5.80796 +82 1 5.29416 16.3645 18.462 -0.365113 -1.85929 1.37874 +83 2 5.65117 15.5929 17.9841 -1.41418 12.24 9.00358 +84 2 5.90904 16.5787 0.535619 -2.78951 -3.81837 -4.76209 +85 1 0.717617 7.68269 4.16298 45.78 12.5398 -25.9452 +86 2 0.140595 7.95484 3.42088 10.68 -3.85526 14.32 +87 2 1.67421 7.98176 3.89702 -61.12 -15.169 17.2669 +88 1 3.20538 9.16537 6.53153 -16.7997 -26.3462 11.633 +89 2 3.63886 8.66012 7.25517 -10.7634 14.1338 -16.8685 +90 2 2.28456 8.785 6.4428 29.8979 17.6904 5.8263 +91 1 7.3492 10.4558 16.1821 -32.1717 -5.51262 30.2531 +92 2 6.6595 11.1272 16.0448 13.9154 -6.26319 -1.99334 +93 2 7.03952 9.99344 16.9918 7.69449 10.9592 -10.5833 +94 1 10.9926 0.857119 5.02234 -5.32556 5.69944 -21.4369 +95 2 11.0071 1.72344 4.58448 5.20867 -2.07691 11.6276 +96 2 10.6449 0.320945 4.28448 4.96755 -3.65716 14.4683 +97 1 4.17972 2.99732 13.1563 8.08367 -30.8511 5.02994 +98 2 4.53886 3.3528 13.9956 -8.94088 -10.2248 -10.148 +99 2 4.12323 1.98418 13.2207 2.50903 42.0947 6.54014 +100 1 8.52337 10.2728 1.80778 10.3789 -10.908 24.8689 +101 2 8.43412 10.9106 2.54849 -2.4679 -8.46295 -11.8092 +102 2 8.72683 9.4118 2.24878 -4.48166 20.4458 -7.62428 +103 1 10.3146 1.66303 15.4651 0.0280032 6.46587 3.16016 +104 2 11.2365 1.5769 15.7049 7.71736 -2.87845 -0.628854 +105 2 10.2832 2.03916 14.5766 -0.873711 -2.30994 -1.44208 +106 1 2.60872 12.9688 7.93078 -1.0685 2.90827 1.70102 +107 2 3.08524 13.7852 7.70925 1.81136 -8.54773 -5.41906 +108 2 2.07592 12.7429 7.1537 2.1601 3.22826 4.8584 +109 1 3.84139 11.714 4.98357 -9.2182 -6.48315 2.00023 +110 2 3.59649 11.1336 5.73363 3.13206 7.92599 -15.0555 +111 2 3.08391 11.75 4.36582 7.48234 -0.753218 11.1676 +112 1 6.65636 14.539 16.9808 1.14971 -3.74934 -0.345026 +113 2 7.45699 15.0461 17.1534 0.734042 -3.82079 -1.22553 +114 2 6.35462 14.7758 16.0963 4.10604 -0.420587 -1.60546 +115 1 14.2186 14.4753 3.18712 8.31434 -1.03143 -11.3814 +116 2 13.7635 15.2982 3.34662 -3.59872 10.6386 -1.06184 +117 2 13.8465 13.8568 3.80574 -6.38377 -9.35153 11.7656 +118 1 8.76639 18.036 16.1575 -17.2352 -7.71273 4.18589 +119 2 9.29865 17.253 16.446 -1.99578 26.3863 -16.3924 +120 2 9.21082 0.13577 15.7005 10.7734 -16.3176 12.3305 +121 1 4.70057 1.84937 4.90583 -5.59427 22.8387 -36.2464 +122 2 3.793 2.25175 4.86575 28.8401 -10.2604 4.23254 +123 2 5.1801 2.18711 4.08016 -18.9233 -12.3263 38.2061 +124 1 15.0501 12.6021 16.5687 -12.0311 0.26828 5.88874 +125 2 14.6786 12.8761 17.4109 9.53333 3.55003 6.01908 +126 2 14.2645 12.5148 16.0221 4.98358 -1.43573 -15.5641 +127 1 15.7004 18.5129 16.8573 39.713 -3.42746 23.3516 +128 2 16.4681 18.7143 17.5055 -38.5977 -15.0096 -30.817 +129 2 15.6109 17.5396 16.7903 -2.54574 14.9499 6.02131 +130 1 1.36802 1.35817 16.6529 -7.19601 7.74866 13.6684 +131 2 2.15913 1.86948 16.876 -3.57304 -8.28302 -6.01627 +132 2 0.751389 1.61649 17.3659 4.93092 -7.13328 -12.7379 +133 1 18.2443 4.33431 15.8699 4.87602 -2.4936 -15.9817 +134 2 17.8369 3.63124 15.3424 2.32992 6.4949 4.25729 +135 2 0.452078 4.51482 15.4394 -9.42811 -2.49011 8.2103 +136 1 12.0529 17.1173 16.1421 -28.5646 -13.5401 15.8604 +137 2 11.3287 16.6705 16.6559 24.6179 11.2855 -13.6919 +138 2 11.708 17.1501 15.239 10.7504 0.848438 1.34073 +139 1 16.0751 2.69533 18.2299 -16.8426 22.7601 -19.9608 +140 2 15.7518 3.52741 18.6545 8.16925 -19.768 -14.2608 +141 2 15.768 2.75869 17.2894 6.47211 -5.43997 24.4047 +142 1 6.70105 13.7211 10.0493 -2.92253 -3.29615 13.924 +143 2 6.49616 13.3451 10.9223 2.46715 2.87816 -3.90822 +144 2 6.5701 13.0016 9.42848 5.58743 -2.71244 -4.10916 +145 1 10.1642 18.4563 2.66846 -6.4553 9.35236 -16.0973 +146 2 10.4494 0.522706 2.05557 -0.598662 -14.7868 7.93587 +147 2 9.23943 18.2921 2.43567 5.35466 0.524311 4.08806 +148 1 3.08905 17.6286 6.23363 28.1073 -1.15148 23.9606 +149 2 2.19758 17.5876 5.91536 -10.6529 4.22104 -18.8026 +150 2 3.7136 17.7221 5.50184 -12.297 -3.14114 -7.6924 +151 1 12.6187 16.7784 7.83399 -8.24743 2.38577 1.37984 +152 2 11.9273 16.0794 7.74003 7.37944 21.7069 5.85683 +153 2 12.3535 17.4638 8.48865 -0.622135 -17.7991 -6.24189 +154 1 14.8741 15.2807 8.33754 11.6667 3.93031 -5.87838 +155 2 14.2607 15.9458 8.0029 -4.6938 -2.09697 8.01324 +156 2 15.5465 15.2244 7.63778 -8.32879 0.363275 5.25782 +157 1 17.8358 18.3077 0.207666 -46.6557 3.82667 -12.4063 +158 2 18.5381 17.6928 0.20107 34.3258 -19.0599 -1.41311 +159 2 18.1099 0.429917 0.68066 12.6369 19.0779 11.4558 +160 1 0.768971 10.519 1.45234 -14.3967 -19.3664 19.1268 +161 2 -0.0407552 10.0454 1.78172 23.5075 9.70284 -14.2764 +162 2 0.503185 11.1892 0.827858 -7.10365 8.12718 -9.46819 +163 1 1.82037 12.3064 3.2607 -0.411525 2.12628 17.6018 +164 2 1.36119 11.682 2.70611 -2.67447 -10.2614 -7.1426 +165 2 2.03731 13.0482 2.69872 0.079619 5.20365 -3.96737 +166 1 0.725717 17.3003 4.98992 32.4002 3.58468 -34.9181 +167 2 -0.000639544 17.8885 5.08952 -19.7566 14.3988 12.6832 +168 2 0.713313 16.5777 5.58791 -15.4184 -21.9192 25.4801 +169 1 0.951486 0.797441 9.37101 14.826 11.188 -16.0996 +170 2 1.14791 0.588384 10.2838 -3.41112 -8.44303 11.2353 +171 2 0.0745467 0.497625 9.13864 -8.88294 -4.64793 9.22513 +172 1 16.8073 2.38946 13.4769 5.39787 -10.4284 -8.99471 +173 2 17.0506 2.69304 12.5747 -8.0967 -7.05722 13.8788 +174 2 16.5161 1.45381 13.4188 4.66162 13.0486 -2.08534 +175 1 2.62912 16.0502 12.0784 8.40953 -12.472 -10.7904 +176 2 3.04385 15.7269 12.8881 -2.37218 0.184289 -5.79457 +177 2 3.10949 15.6337 11.3228 -8.7582 6.42497 16.6586 +178 1 16.3457 15.4302 6.12389 30.9011 24.8554 -18.1041 +179 2 17.2992 15.5349 6.36757 -22.0844 -7.23183 -0.993592 +180 2 16.19 16.1865 5.50068 -1.85714 -20.6143 14.9819 +181 1 5.77873 5.21745 11.785 11.0193 -20.9315 -11.6683 +182 2 5.50793 5.92484 12.3546 -4.36629 16.5013 7.19057 +183 2 5.27867 4.45162 12.0794 -6.37659 -1.59945 -1.70387 +184 1 15.1747 4.94504 0.761547 -29.5175 -4.13494 28.6724 +185 2 14.9952 4.57194 1.67189 6.69018 16.901 -24.5633 +186 2 14.3176 5.30548 0.449447 18.0211 -8.94221 4.63226 +187 1 16.4144 16.461 1.77501 8.34865 -5.69196 -8.65308 +188 2 16.356 16.7636 2.67626 -8.71628 3.92983 13.8981 +189 2 16.7832 17.2073 1.29403 -0.614878 1.7319 -3.63708 +190 1 0.136057 4.8659 3.98965 34.6037 22.2365 -2.60366 +191 2 0.554963 5.79058 3.9624 -19.788 -38.6093 6.27627 +192 2 0.840291 4.21253 4.20207 -10.6708 20.7839 -4.14843 +193 1 2.91044 15.0804 15.1041 7.34684 -10.5058 14.2682 +194 2 2.90482 14.7198 16.034 -7.41786 16.0657 -24.8201 +195 2 2.46761 15.9418 15.099 -2.49045 -2.68752 9.6724 +196 1 0.98952 14.6361 9.40184 3.41519 -3.90395 6.55514 +197 2 1.54705 13.945 9.00075 -6.08548 3.23571 10.1521 +198 2 0.78947 14.3674 10.3125 0.535168 -4.82993 -11.1122 +199 1 13.5676 16.5089 11.5672 -19.673 9.58551 -20.9583 +200 2 13.2883 17.2623 10.9814 5.35041 -18.2182 15.9177 +201 2 13.0352 15.7491 11.2513 9.15027 7.77217 2.32965 +202 1 4.84709 1.60354 0.665871 -13.2454 -7.94988 -14.2061 +203 2 4.37724 2.10746 -0.0295305 4.1335 -5.07179 15.4313 +204 2 4.23428 0.890311 0.93575 7.29231 10.3056 3.49355 +205 1 1.57562 18.6232 11.9448 -9.54215 3.4719 -19.1533 +206 2 1.53947 0.452662 12.7669 0.622104 8.67092 13.3018 +207 2 1.94164 17.7639 12.1401 7.67295 -5.68018 1.31967 +208 1 11.3828 10.0809 4.23132 25.5406 -0.783734 -33.5194 +209 2 11.2477 10.3841 3.29047 7.40472 -5.62792 30.1478 +210 2 12.3604 9.90108 4.31318 -36.068 9.82931 1.34024 +211 1 8.1924 12.225 3.79726 -5.69748 14.5101 56.1678 +212 2 9.05523 12.5573 4.13122 -12.2475 -6.42112 -18.1901 +213 2 7.61811 12.3317 4.63279 18.664 -10.6547 -44.172 +214 1 14.6446 4.04033 3.3856 3.29585 4.20735 14.8065 +215 2 15.1799 4.13354 4.21231 -10.8641 -1.34483 -21.0767 +216 2 13.7289 4.27483 3.60977 8.83721 -0.102893 1.13309 +217 1 5.73789 1.70847 7.633 -45.2268 -33.2589 19.0394 +218 2 5.00558 1.12579 8.07813 40.2552 34.7696 -21.6936 +219 2 5.52319 1.67762 6.69069 2.06189 0.609235 -2.30714 +220 1 17.8554 0.94247 4.83325 2.84508 1.94772 -6.32822 +221 2 18.4375 1.13729 4.06994 -6.68522 3.20321 14.3473 +222 2 17.8361 1.70281 5.4359 2.52705 -5.98387 -7.60558 +223 1 6.82607 9.13014 4.53731 -2.03949 -2.27606 -0.824268 +224 2 6.749 9.37751 5.45829 -4.27203 4.05265 7.19029 +225 2 7.76352 8.95198 4.44117 4.86868 -1.78157 -6.05796 +226 1 2.39805 14.6397 2.05874 17.0918 -1.49078 4.46086 +227 2 3.17145 14.6314 2.66377 -10.8679 0.525641 -12.6634 +228 2 2.72903 14.4183 1.17543 -1.81421 4.03234 5.90777 +229 1 17.1796 12.9575 13.0281 -10.0626 2.91445 0.0973403 +230 2 16.3048 13.3397 13.2675 20.7192 2.62525 -4.36947 +231 2 17.7682 13.6617 12.6978 -15.1419 2.46765 5.43564 +232 1 14.7925 10.5715 1.51204 -8.6843 -36.4521 -19.1925 +233 2 15.3686 11.2103 1.85793 27.186 33.4644 17.5702 +234 2 13.9217 10.9161 1.62765 -18.2001 7.18743 0.677482 +235 1 5.63756 6.65584 4.53835 -5.70194 -14.7917 8.95129 +236 2 5.96892 7.55557 4.50237 4.06113 5.5935 -1.33512 +237 2 6.19689 6.19506 5.18786 2.48768 6.43185 -8.34619 +238 1 8.1035 8.32015 10.3633 -6.06951 -1.51391 13.5103 +239 2 8.71051 8.88696 9.88772 3.75134 6.39998 -5.242 +240 2 7.4427 8.01108 9.7382 -0.891776 -1.59521 -4.95879 +241 1 13.4554 18.4382 5.64567 -23.0826 -2.6609 26.3697 +242 2 12.6541 0.350227 5.51512 12.1971 -9.37205 -2.29397 +243 2 13.2308 17.8847 6.43702 5.12544 9.06169 -21.995 +244 1 0.0481459 2.53289 0.450073 0.762545 20.3906 -8.36614 +245 2 17.7393 2.57826 18.829 23.3906 9.65711 1.86789 +246 2 0.50996 3.41343 0.303855 -21.6669 -27.8541 1.68488 +247 1 12.9745 10.8048 9.65469 -32.5048 41.5261 -13.285 +248 2 12.0083 11.0976 9.65119 33.8953 -25.1931 3.11551 +249 2 13.0333 9.87229 9.85209 -8.8072 -6.07099 4.09073 +250 1 0.527116 12.3319 11.2575 10.4347 -0.622496 2.4881 +251 2 18.2313 12.2915 11.4294 -10.2968 -1.46033 -6.74513 +252 2 0.909084 12.5363 12.117 7.12796 0.366826 -3.41572 +253 1 5.28415 7.34725 13.2845 -6.32664 2.65038 2.55184 +254 2 5.64713 8.17412 12.9655 4.82658 4.12789 -9.57053 +255 2 5.74627 7.2293 14.1116 0.316635 -7.58532 9.69513 +256 1 1.16454 6.74183 12.03 -13.1625 -42.3004 -9.02199 +257 2 0.295417 6.98712 11.7254 -9.09418 5.46945 -3.0829 +258 2 1.57891 7.53521 12.2772 19.8541 36.5775 12.6901 +259 1 15.5783 9.75012 12.4577 9.71681 16.8235 16.5595 +260 2 15.2431 10.6351 12.2158 0.950441 -15.6258 3.07953 +261 2 16.0853 9.89705 13.2804 -12.0519 -4.92211 -13.1427 +262 1 16.5993 12.6285 5.60521 -10.2494 37.6021 -45.7262 +263 2 16.4242 13.6113 5.62967 5.67224 -29.3823 14.3376 +264 2 16.441 12.4706 4.63081 7.92181 -5.25591 31.2114 +265 1 6.41284 9.90681 0.119653 0.515871 -10.7086 -9.9123 +266 2 5.64934 10.3727 0.465056 -3.06655 2.33505 3.46562 +267 2 7.14462 10.1266 0.702846 2.16363 1.41956 4.36049 +268 1 12.2095 5.93838 4.00309 -11.5544 -2.90268 -3.08172 +269 2 12.2942 6.66752 3.37735 2.08742 0.382808 1.33145 +270 2 11.2587 5.74648 4.01779 6.74513 0.670066 1.17813 +271 1 0.342924 12.9268 0.00967172 -2.71894 -2.13654 5.95194 +272 2 18.7348 13.4393 0.793746 3.88983 0.588143 -5.53597 +273 2 18.4589 13.2921 17.9296 1.41778 -5.28425 5.34754 +274 1 3.57599 18.7244 8.67011 -7.57313 7.8026 -17.3863 +275 2 3.53053 18.3214 7.79351 4.94999 -5.98969 2.51912 +276 2 2.6975 0.472694 8.72681 1.72246 -0.921876 11.7862 +277 1 7.19816 17.4543 4.42938 13.0422 27.6578 -13.842 +278 2 7.51541 18.3714 4.6455 -6.70989 -26.1973 -6.43912 +279 2 7.34255 17.3635 3.4592 -3.95356 0.0926602 20.0901 +280 1 9.24276 17.181 12.1874 27.1924 -9.91753 -12.8104 +281 2 9.16544 16.536 11.4403 4.06483 10.4089 22.9332 +282 2 10.1989 17.1789 12.4847 -33.3611 -0.423317 -5.22003 +283 1 13.2427 13.2324 7.99028 -4.63127 -11.2433 10.7708 +284 2 13.2975 12.5097 8.63573 0.309708 1.2863 -7.28868 +285 2 13.9184 13.8596 8.25103 7.01778 4.96536 -0.211076 +286 1 14.7706 2.86972 15.5058 12.3246 -20.976 -18.3849 +287 2 14.0341 2.28041 15.2496 10.8751 5.18171 6.07562 +288 2 15.4548 2.72916 14.8136 -15.3015 9.06101 10.4071 +289 1 9.96013 15.6554 16.9624 -0.416257 -4.3558 -3.6035 +290 2 10.3061 14.8055 16.6414 -1.75696 6.53817 2.71112 +291 2 9.61308 15.4752 17.8389 -3.07369 -3.40172 1.73448 +292 1 11.2206 8.54091 16.6271 11.2119 0.246209 -0.153837 +293 2 10.3853 8.13843 16.425 -12.7378 -7.75768 -8.20822 +294 2 11.7159 7.85532 17.0695 3.92811 -4.5145 7.83184 +295 1 4.19128 18.3534 16.7936 -2.0541 -15.6573 2.75359 +296 2 4.49896 17.6946 17.4386 1.3239 2.14246 -6.87061 +297 2 4.3476 0.553135 17.2025 -0.294224 9.43754 2.6314 +298 1 2.38271 4.321 8.90759 20.0465 -16.3105 29.2362 +299 2 3.33364 4.03277 8.87737 -27.5446 13.4253 -3.78204 +300 2 2.08958 4.1083 9.83354 7.71669 6.29647 -26.7475 +301 1 9.9842 10.4369 9.88352 -17.0195 21.6351 -0.0387615 +302 2 9.44133 11.1731 9.47934 17.4922 -21.0458 18.4718 +303 2 9.94225 10.4854 10.8652 2.27572 1.94662 -18.6097 +304 1 9.85899 0.920399 10.8075 0.162278 -2.63975 1.09763 +305 2 9.48302 0.0750215 11.0855 -2.58178 2.3482 3.77053 +306 2 9.21377 1.33985 10.2254 -0.0206645 -1.54215 -2.59695 +307 1 9.16055 15.229 10.2075 -19.4407 -6.65372 -14.862 +308 2 8.92137 15.8821 9.51239 -0.317996 -13.1788 14.0466 +309 2 8.43697 14.5477 10.1944 18.1534 21.6077 -0.815821 +310 1 0.71674 9.75329 10.1461 2.10813 23.2969 8.50765 +311 2 0.819344 10.7283 10.3167 -3.94998 -28.3852 -4.44668 +312 2 1.15296 9.53542 9.32246 0.728257 4.55427 -3.87479 +313 1 17.2456 4.88922 8.01698 -15.6269 -0.477795 25.7007 +314 2 16.4423 5.19943 8.52213 28.7194 -9.29348 -15.89 +315 2 17.7804 4.31587 8.60398 -15.5446 9.64156 -7.98894 +316 1 14.822 14.6129 0.044879 1.26259 -7.26488 27.1569 +317 2 15.5503 14.8635 0.654609 -16.5042 1.70925 -13.2775 +318 2 14.1019 14.3181 0.644441 11.2495 5.19015 -13.4399 +319 1 3.93398 11.151 9.56657 -13.0999 1.1143 6.92396 +320 2 3.8819 11.1389 10.5379 -0.108421 8.58768 -6.25849 +321 2 3.2885 11.8101 9.24754 8.95434 -7.44407 0.420275 +322 1 11.481 10.7372 1.49136 -12.2308 11.5287 -6.19882 +323 2 11.6479 11.6347 1.11375 -3.03535 -20.3842 8.82813 +324 2 10.5208 10.5745 1.38561 13.1816 3.92224 -1.496 +325 1 13.1382 7.21836 12.5396 -14.3564 7.08975 0.177427 +326 2 14.0771 7.12045 12.4061 13.875 -7.92794 3.07029 +327 2 12.7619 6.3345 12.5945 1.25366 -4.42296 3.81153 +328 1 9.68698 1.99848 0.824055 10.3256 0.727137 24.2023 +329 2 8.81917 1.78721 0.50968 -15.0497 -1.62599 -5.65 +330 2 10.155 2.38703 0.0980655 8.32187 5.69202 -13.7925 +331 1 10.602 13.3929 4.55586 17.4753 0.473987 25.0493 +332 2 11.4671 12.9458 4.66597 -13.9744 4.33191 -5.6004 +333 2 10.4831 13.8198 5.42698 -1.33045 -1.26907 -13.5894 +334 1 14.5505 1.55995 10.9504 0.793491 3.39408 -6.18689 +335 2 15.3506 1.17936 10.5364 -11.0229 12.1378 4.59402 +336 2 14.5582 2.53024 10.8225 7.4254 -12.0179 1.55597 +337 1 14.4508 12.0407 11.6074 10.4267 -5.99888 -36.1251 +338 2 15.2905 12.2256 11.0848 -31.5625 -1.98982 15.431 +339 2 13.8033 11.6041 10.9773 26.0423 16.8772 21.3357 +340 1 8.16091 5.15464 9.81808 -31.1733 -3.04727 19.1057 +341 2 7.28259 5.21015 10.2725 23.9466 4.77499 -10.0641 +342 2 8.23945 4.21356 9.63446 4.25293 -1.90524 -4.29988 +343 1 1.57078 16.9857 18.5145 2.11582 4.65495 -1.34384 +344 2 1.81738 17.3492 17.6562 0.32294 -2.46744 1.69741 +345 2 1.87051 16.0745 18.5076 0.982883 -4.60963 -1.80737 +346 1 1.40224 17.4231 15.3612 30.835 -28.8708 -16.9337 +347 2 1.58171 18.2262 15.8024 1.01568 35.607 16.5514 +348 2 0.474852 17.284 15.3634 -28.8421 -6.17683 0.802216 +349 1 3.44554 5.70547 6.04619 4.62282 22.475 -0.524537 +350 2 3.1428 6.44974 6.61309 0.90031 -17.6364 -10.4242 +351 2 4.06586 6.09018 5.39907 -5.11167 -0.757253 7.03456 +352 1 12.635 9.5385 14.2471 10.4135 -57.691 -2.75625 +353 2 13.0561 8.75521 13.7543 -17.7171 41.3381 15.7803 +354 2 12.3533 9.10151 15.082 0.88858 17.3566 -13.7461 +355 1 4.11217 15.1814 7.19429 24.0597 14.9458 -6.20919 +356 2 3.65166 15.9525 6.80506 8.00815 -8.18076 7.53786 +357 2 5.09537 15.3539 7.08579 -34.9804 -3.92885 1.78443 +358 1 0.830872 8.84313 15.1657 1.50937 4.0339 -6.81168 +359 2 0.547306 9.77972 15.0966 9.11455 -14.6477 -1.64448 +360 2 1.6109 8.72602 14.589 -11.0561 6.95599 3.23137 +361 1 12.8981 8.26079 10.0923 10.5692 -21.7103 -4.02448 +362 2 13.6229 7.70102 9.77244 -0.136865 10.7899 -7.02632 +363 2 12.7945 7.93077 10.9815 -6.52785 3.68747 11.7154 +364 1 15.1981 8.09018 3.38532 -13.0459 -52.6521 2.11346 +365 2 14.5247 7.61376 2.86907 3.36606 26.685 -8.7616 +366 2 15.3386 7.39586 4.05885 15.5852 26.7124 4.01456 +367 1 17.1365 6.7605 0.0284285 -19.4133 2.32297 -2.08842 +368 2 16.6422 5.96523 0.300426 11.1165 9.80228 -2.81184 +369 2 16.4267 7.37993 18.3943 16.5678 -7.00446 5.84521 +370 1 8.97527 7.00353 7.90402 -12.8517 -1.3564 7.9131 +371 2 9.8962 7.25242 7.83012 8.98921 2.98997 4.36252 +372 2 8.82463 6.62979 8.79874 5.5237 0.780274 -18.1173 +373 1 12.5342 0.599732 1.22272 7.37234 -11.2249 5.10795 +374 2 13.3221 0.863275 1.71742 -3.27048 6.46822 -3.34517 +375 2 12.885 0.18837 0.429335 -4.8121 3.35952 -2.50919 +376 1 5.70486 15.0289 14.4325 -10.0966 26.0987 -8.04315 +377 2 4.75654 15.1126 14.6498 8.83064 -2.51751 -1.0487 +378 2 5.99172 15.9344 14.1552 -2.67099 -19.6319 8.34541 +379 1 3.68772 6.51886 1.67786 -9.02664 17.532 -4.1283 +380 2 3.3123 7.35563 1.32777 6.95322 -18.4916 -0.718273 +381 2 3.69933 6.70385 2.62114 4.49099 -5.2411 1.79351 +382 1 3.84119 11.2683 12.301 -11.0219 1.87445 3.30422 +383 2 4.7083 11.6207 12.5295 0.62865 1.71432 1.43021 +384 2 3.16952 11.829 12.7259 9.18863 0.324364 -2.3982 +385 1 5.33774 3.90131 15.6575 3.88008 58.1131 -0.302695 +386 2 6.0029 3.30263 15.356 18.6017 -19.7261 -0.90724 +387 2 5.77609 4.81808 15.6348 -20.8077 -39.2998 1.51453 +388 1 13.9476 10.0954 4.76119 43.1598 -13.631 -14.8551 +389 2 14.3099 9.89525 5.64952 -11.5358 -2.78357 -16.2598 +390 2 14.5437 9.62633 4.09138 -26.3956 16.5702 30.5617 +391 1 7.47949 17.2779 8.9575 1.27559 12.2273 10.3752 +392 2 6.80648 17.541 9.63427 13.3482 -0.885269 -20.4433 +393 2 7.81637 18.0666 8.4826 -8.0179 -7.75644 7.92076 +394 1 4.60365 14.3557 3.73459 -2.67085 -0.0597314 40.4087 +395 2 4.53549 15.2621 4.14744 4.43815 -28.6634 -11.7113 +396 2 4.62044 13.6529 4.46513 -1.80956 31.3212 -27.6241 +397 1 14.2431 7.29194 15.9057 25.6353 16.9765 2.1683 +398 2 15.0475 7.32515 15.3368 -17.0197 -3.00413 14.2387 +399 2 14.4656 7.87429 16.6673 -6.53416 -15.6271 -13.0076 +400 1 2.96496 18.4208 1.99119 15.7852 32.1682 20.7835 +401 2 2.67672 17.8955 1.28044 -15.5564 -27.5435 -28.9446 +402 2 2.23493 0.385121 2.17733 5.2916 -3.96739 2.45348 +403 1 7.98476 1.5873 4.50407 1.38949 2.52923 0.695279 +404 2 7.37343 2.0449 3.91068 5.19751 -1.80104 2.00097 +405 2 8.86519 1.9238 4.29038 -5.22298 -3.29695 -0.501883 +406 1 2.57117 14.1691 17.7571 1.007 -17.2424 4.53378 +407 2 1.90219 13.4698 17.9606 14.5878 19.4169 -2.4542 +408 2 3.44824 13.7555 17.8862 -10.6426 1.83574 2.42644 +409 1 1.00451 2.03285 13.8784 10.3502 2.39599 -10.3714 +410 2 1.16144 1.84563 14.7992 2.97823 -2.88805 14.0985 +411 2 0.0700994 1.90667 13.7535 -13.5508 1.82952 -2.05389 +412 1 4.33902 0.200757 13.8843 13.0721 -10.005 -1.30306 +413 2 5.22858 18.4296 13.858 -15.0619 9.43809 1.75921 +414 2 3.93054 18.5168 14.6942 4.28146 4.19272 1.73225 +415 1 7.39543 1.05973 18.4904 -6.66444 -3.84456 4.72925 +416 2 7.66739 0.634389 17.6825 2.48525 -3.87431 -15.5197 +417 2 6.44311 1.20989 18.4324 3.08246 -0.882049 5.31666 +418 1 15.7652 18.4035 13.928 -3.86344 6.1861 11.5309 +419 2 14.8535 18.6979 13.7607 9.26883 -6.83338 6.65234 +420 2 15.8985 -0.310566 14.8997 -7.7909 7.80446 -17.2978 +421 1 10.2952 4.64795 16.1844 -42.7729 -17.7833 -2.18791 +422 2 11.2045 4.84382 16.2798 37.5776 1.06228 1.58962 +423 2 10.2217 3.67206 16.1998 1.46017 15.0252 -2.22652 +424 1 15.8927 17.6472 4.46477 -15.4234 23.5431 17.5975 +425 2 16.4754 18.4255 4.65687 -16.3789 -18.5079 -6.3799 +426 2 14.9773 17.9018 4.78742 33.6258 -6.52099 -13.8394 +427 1 6.90155 17.6195 13.966 46.0362 -18.082 7.69792 +428 2 7.5054 17.5909 14.7751 -24.8486 6.04139 -28.3759 +429 2 7.50943 17.3755 13.214 -16.8133 11.713 21.5591 +430 1 13.2082 6.37265 6.52765 -13.548 -6.29238 7.5029 +431 2 14.0171 6.83631 6.34759 17.8515 4.0742 0.884882 +432 2 12.7912 6.26458 5.66961 -1.80962 -1.49443 -3.94736 +433 1 7.85263 2.26509 9.52735 -7.99894 -5.84405 -22.7054 +434 2 7.25184 2.06178 10.2504 -3.996 2.15095 3.09306 +435 2 7.39499 1.97805 8.69805 10.2818 7.88442 20.3126 +436 1 15.1135 14.8377 13.7906 -14.0873 7.85215 4.54273 +437 2 14.8065 15.1503 14.6696 4.89633 -5.66092 -15.9193 +438 2 14.526 15.2486 13.1323 8.68819 -2.70507 8.56313 +439 1 9.34389 8.42481 3.82801 17.2784 -12.6228 -3.36469 +440 2 10.2481 8.71643 4.0808 -19.781 -0.493733 -4.13474 +441 2 9.39514 7.45876 3.71283 -1.01674 10.6173 4.41109 +442 1 17.6406 13.5721 16.5094 2.04355 14.6677 -13.2606 +443 2 16.6957 13.3564 16.5004 3.03121 5.86868 -4.35941 +444 2 17.7908 14.3862 15.9732 -9.46726 -16.3028 8.56732 +445 1 4.98477 10.3524 2.78056 12.7386 5.36526 19.5004 +446 2 5.77841 9.87677 3.08402 -8.11584 2.70387 -5.95057 +447 2 4.78102 10.9105 3.55814 -3.18863 -4.34789 -14.1468 +448 1 3.61985 8.409 9.90418 -6.90754 6.83907 7.996 +449 2 3.65115 9.35813 9.71914 3.08439 -3.40065 -3.71786 +450 2 3.2182 8.36489 10.7858 3.70965 -2.47637 -5.74153 +451 1 15.9601 6.9243 5.80742 5.84252 7.06727 3.15212 +452 2 16.6786 7.33659 6.3256 -10.6597 -9.43019 -8.8571 +453 2 16.2068 5.99858 5.66915 1.21675 5.97088 2.68601 +454 1 15.2845 7.30815 8.96614 12.789 49.367 -12.5087 +455 2 15.9618 7.62249 9.60336 -10.429 -10.3168 -7.48119 +456 2 15.189 8.09577 8.33246 -3.07462 -40.144 23.8491 +457 1 6.1828 12.7537 12.7561 7.28509 13.2747 4.63662 +458 2 7.05451 12.4627 13.0861 -13.4204 -0.208789 -0.140696 +459 2 5.95622 13.5898 13.2147 8.13015 -13.1574 -2.88232 +460 1 12.1263 4.55994 13.1396 29.7192 24.8274 2.05513 +461 2 12.1786 4.68706 14.0984 -0.0287765 -3.56256 -2.83377 +462 2 11.367 4.05454 12.9285 -29.3831 -17.3036 -0.987503 +463 1 11.4694 8.07241 7.80966 2.82892 -5.30182 3.11258 +464 2 12.1089 7.42736 7.43222 -7.16455 14.3649 9.80055 +465 2 11.7078 8.26067 8.74179 3.19872 -8.99269 -16.594 +466 1 16.9463 10.7531 7.60486 21.0922 -19.3927 -30.7185 +467 2 17.5464 10.0071 7.31859 -16.0594 21.8542 15.0855 +468 2 16.9098 11.3402 6.82058 -3.06841 -4.58473 14.7168 +469 1 5.28146 18.0409 10.6472 -25.9515 -7.83546 -6.26387 +470 2 4.85268 17.2439 11.0337 11.609 18.382 -10.1496 +471 2 4.62194 18.3715 9.98111 20.3861 -11.8767 18.8687 +472 1 7.65293 17.466 1.56177 -3.43219 -2.17163 16.4468 +473 2 8.27069 16.8213 1.23778 3.23069 -17.6415 -5.16563 +474 2 7.58305 18.0963 0.859771 -3.72786 20.9018 -9.77855 +475 1 1.92587 12.9087 13.6164 -8.16731 5.11551 18.4441 +476 2 1.30634 12.3949 14.1755 13.4846 7.44573 -7.00244 +477 2 2.13079 13.7319 14.1159 -1.95883 -16.9131 -9.84331 +478 1 9.29336 6.75339 14.7687 -19.1125 21.7104 1.76678 +479 2 9.711 5.9819 15.1082 15.9481 -24.452 8.13362 +480 2 9.58853 6.88119 13.8676 2.75751 0.822828 -8.36077 +481 1 15.2452 4.28737 10.7623 -0.225576 -4.08648 -1.74219 +482 2 16.1503 3.99339 10.8719 6.1947 -5.72264 -8.71474 +483 2 15.1717 4.92602 11.4736 -7.0877 3.5816 0.665059 +484 1 11.4391 6.24473 0.0517087 -15.4849 -28.4826 -7.88372 +485 2 11.5335 5.29025 18.4586 5.11122 21.8085 5.83846 +486 2 10.469 6.36117 18.7264 13.3105 4.99187 -1.92993 +487 1 18.4571 11.4845 14.9094 -8.14212 27.2991 -26.8701 +488 2 18.0442 12.0056 14.1458 10.7134 -26.1217 30.6713 +489 2 18.3691 12.0954 15.6567 -1.55188 -2.54901 -1.51407 +490 1 7.07006 9.2713 7.35429 3.52198 -23.4346 -4.90088 +491 2 6.57918 8.46088 7.59869 6.01934 15.522 -0.341791 +492 2 7.98054 8.95273 7.2441 -4.91945 6.78887 2.19469 +493 1 18.4213 15.3485 12.1512 14.6289 14.7183 -5.00343 +494 2 0.703338 15.6554 12.0361 -12.928 -5.55139 4.18882 +495 2 17.8805 15.9633 11.6295 -1.60931 -6.92771 2.64168 +496 1 16.5853 4.3259 5.32941 -3.23822 -14.2219 46.7572 +497 2 16.614 4.15863 6.32722 1.43031 7.89007 -40.0485 +498 2 17.5031 4.43236 5.0545 -4.12857 4.88068 -4.00684 +499 1 17.7656 3.15988 10.7489 -7.77815 -3.54726 5.22618 +500 2 18.6517 3.33727 11.1036 -6.02481 -6.41431 -8.69585 +501 2 17.7347 2.25304 10.4054 5.10772 5.83768 0.491016 +502 1 12.3532 18.6195 10.0845 2.26138 29.9542 0.82462 +503 2 11.4554 0.369133 10.2956 34.814 -7.7062 -6.49387 +504 2 13.0539 0.703372 10.1287 -31.4455 -25.8056 2.12568 +505 1 10.4062 9.7592 12.5463 4.94309 9.48659 9.1975 +506 2 11.1178 9.86775 13.2051 -4.84217 -3.21907 -8.75193 +507 2 10.4169 8.83 12.3092 -0.242296 -5.43122 1.67162 +508 1 0.754807 2.57366 7.2759 5.10959 9.37805 -1.17349 +509 2 1.15147 3.40426 7.59563 -2.53061 -11.14 3.70439 +510 2 0.94825 1.90755 7.95351 -0.370046 8.4477 -4.76995 +511 1 0.326852 15.3245 6.92393 7.78779 -47.7914 -15.9381 +512 2 0.478367 15.1955 7.87742 -3.54148 6.5065 -12.4551 +513 2 0.511792 14.4078 6.50445 -6.22026 47.2618 21.2659 +514 1 17.0448 6.87527 14.9011 7.50868 -3.64469 2.18783 +515 2 17.7829 7.50382 14.839 -4.82102 -5.02166 1.59119 +516 2 17.384 6.09018 15.3732 -3.19441 8.7454 -5.86774 +517 1 9.10521 12.4991 8.01627 -22.444 -7.37457 -9.07321 +518 2 9.5155 11.7197 7.59468 -6.97176 5.64777 -5.01838 +519 2 8.17012 12.5725 7.67989 31.3303 -7.17656 9.91942 +520 1 1.12679 1.65794 2.79756 -4.95635 8.46302 6.6874 +521 2 0.642552 2.15227 2.11219 8.6081 -1.07022 6.53976 +522 2 1.60228 2.28223 3.37541 -5.16033 -3.32404 -9.46208 +523 1 4.24509 15.0269 10.0531 -9.28044 4.63084 -2.70058 +524 2 3.93721 15.2031 9.15401 2.26907 2.00751 2.33164 +525 2 5.07496 14.5648 9.92961 6.13338 0.348707 3.17177 +526 1 7.39613 2.22212 14.8791 -10.1428 -2.73186 -2.62368 +527 2 7.12857 1.59843 14.1951 -0.211704 -1.85534 3.14611 +528 2 7.6308 3.01777 14.3992 6.19568 3.75469 -5.36272 +529 1 18.3005 14.5161 2.14907 5.30067 -9.26209 1.4902 +530 2 0.506128 14.8057 2.49377 4.6744 -0.083839 -4.04908 +531 2 17.8019 15.308 1.97101 -9.85855 11.1774 -0.48774 +532 1 10.0782 2.71092 12.8944 3.88974 -3.73664 -2.78909 +533 2 9.88925 2.05355 12.2072 4.3936 3.86452 2.74403 +534 2 9.31937 3.3006 12.9074 -3.94823 0.261307 -1.05017 +535 1 2.9306 8.79131 12.9512 -25.6961 -20.8645 -0.44372 +536 2 3.33593 9.62792 12.788 10.417 21.0465 -4.83397 +537 2 3.64632 8.1716 13.058 11.1871 -7.80414 6.67576 +538 1 3.17851 8.59155 3.78391 36.0219 9.48042 20.5594 +539 2 3.64638 9.17092 3.16182 -4.0064 -4.18597 2.27442 +540 2 3.67104 8.74964 4.63715 -24.9674 -6.25544 -24.3579 +541 1 5.79667 7.27872 8.61723 -5.158 -8.45889 2.36629 +542 2 5.76122 6.32524 8.453 -1.10357 3.40671 2.32671 +543 2 5.00318 7.4879 9.12925 4.38374 0.567505 0.838777 +544 1 14.9116 1.65307 1.84567 7.03031 -5.18946 -10.6018 +545 2 15.1062 2.45757 2.3139 -4.94852 6.93451 15.0643 +546 2 15.1691 1.84916 0.935056 -0.310542 -6.30296 3.0909 +547 1 8.67523 15.0369 0.613894 1.37845 1.1536 3.61737 +548 2 9.43682 15.0729 1.21213 -3.42809 -6.51916 3.89646 +549 2 8.00447 14.4711 1.03609 4.49017 7.63347 -1.72767 +550 1 15.3993 1.47022 7.19229 -20.8703 -2.58026 0.276614 +551 2 14.6837 0.967989 6.72584 19.4319 15.0033 11.4079 +552 2 14.9834 2.26826 7.5843 2.60239 -12.333 -11.18 +553 1 4.89704 12.855 18.4725 17.7474 3.66438 12.0852 +554 2 5.22521 13.0209 0.739851 -5.30909 -3.44768 -15.7686 +555 2 5.64886 13.1114 17.9131 -8.88833 1.88365 4.35483 +556 1 15.3966 8.71526 18.0579 -0.0737912 10.217 -6.92241 +557 2 15.7913 9.20885 17.3059 -4.72516 -6.1114 19.2356 +558 2 15.2466 9.35419 0.13361 -0.210218 -4.05252 -7.18588 +559 1 11.9654 3.16879 18.3684 -1.96391 -6.33771 9.57431 +560 2 11.8782 2.93896 0.667559 5.83177 -2.01678 -11.7343 +561 2 12.3624 2.38725 17.9444 -0.743858 8.0566 3.61175 +562 1 13.1976 12.733 5.19814 3.21154 2.81721 -3.88454 +563 2 13.6265 11.8743 5.11099 -2.80289 -1.59076 -2.45209 +564 2 13.3962 13.0406 6.08845 -1.48061 -3.43823 1.63358 +565 1 6.20234 7.07161 0.291392 8.37087 -8.50913 -15.2358 +566 2 6.21431 8.03007 18.9132 -3.08565 9.14852 3.50692 +567 2 5.28911 6.79756 0.384068 -8.05152 4.04277 7.5169 +568 1 17.755 15.8811 14.8809 -0.846783 4.67036 -1.95176 +569 2 16.8205 16.1356 14.922 6.46156 -5.25763 -8.70949 +570 2 17.9775 15.7319 13.9423 -7.01069 1.37948 9.8425 +571 1 13.0816 0.927432 16.7559 7.19813 -13.1533 1.9849 +572 2 14.0246 0.654652 16.7787 -14.5584 8.9122 1.46691 +573 2 12.5958 0.0867106 16.6751 4.09548 8.26383 -2.86333 +574 1 10.8721 14.5032 7.42074 17.8947 27.9436 -17.0444 +575 2 10.196 13.9242 7.71676 -22.829 -18.2345 11.9548 +576 2 11.6972 14.0514 7.58445 7.42519 -9.80791 -0.577526 +577 1 17.7647 8.42346 2.16939 -4.1598 1.60766 -5.89387 +578 2 16.8709 8.3975 2.49669 -12.234 5.23478 11.868 +579 2 17.7295 7.75318 1.48744 5.54579 -3.65645 -10.0136 +580 1 12.5773 7.79072 2.0332 1.0668 2.49746 -6.2566 +581 2 12.3914 8.73063 1.87761 -0.101344 -7.79782 -0.82295 +582 2 12.2276 7.2965 1.27263 1.31444 5.98607 5.5368 +583 1 12.0208 14.4615 10.4933 -27.7219 6.00234 -17.9899 +584 2 12.3406 14.2687 9.58404 -10.0812 4.98999 20.4987 +585 2 11.0483 14.7039 10.4238 33.6221 -8.97773 -1.58279 +586 1 6.69486 6.68845 15.5484 18.1135 9.98152 11.3143 +587 2 7.65688 6.85274 15.3559 -27.8703 -4.06425 5.81014 +588 2 6.48582 7.17335 16.3722 6.10572 -10.2019 -13.6564 +589 1 7.96659 4.39718 13.2272 4.51058 -7.9075 4.77481 +590 2 7.2893 4.70584 12.6248 -6.54048 3.46732 -4.14994 +591 2 8.21018 5.15068 13.7582 2.30488 10.1178 3.17748 +592 1 13.2671 12.2369 14.4347 -4.64765 -4.51239 1.04229 +593 2 13.0608 11.2949 14.304 4.07546 7.63325 0.952283 +594 2 13.624 12.5445 13.5893 -0.484314 -1.81518 4.66288 +595 1 14.4631 9.64208 7.37348 -3.22195 -17.9745 -8.46037 +596 2 15.2455 10.1455 7.54143 19.6931 12.3162 5.07411 +597 2 13.7594 10.075 7.84063 -11.2512 5.66435 9.63044 +598 1 12.6955 16.8004 3.38503 4.61351 40.5798 -15.2407 +599 2 12.79 17.4151 4.16128 -2.51333 -18.5745 -25.4999 +600 2 12.6728 17.373 2.55111 0.0132769 -17.6878 38.2975 +601 1 0.968812 6.96727 17.3326 -17.527 29.8281 -14.7856 +602 2 0.0966102 7.11435 17.7475 9.38145 -12.9539 -1.45746 +603 2 0.942675 7.56475 16.5473 6.51552 -11.7527 16.88 +604 1 12.9918 4.86088 15.7598 14.9884 1.53364 0.213735 +605 2 13.6417 4.12341 15.6561 -13.2544 27.5281 4.62454 +606 2 13.5036 5.69571 15.8607 -8.5455 -17.4296 -3.38108 +607 1 2.31456 3.41181 5.02375 -16.8072 14.5355 28.5245 +608 2 1.72499 3.01856 5.74541 26.0591 16.5367 -23.5498 +609 2 2.61813 4.33638 5.31016 -13.7452 -42.3935 -5.38282 +610 1 8.12877 10.8743 13.7813 26.8177 -26.1009 35.9685 +611 2 8.08888 10.4248 14.7095 5.12746 27.8083 -58.2879 +612 2 8.93477 10.511 13.3312 -19.2021 7.65314 13.0743 +613 1 13.0038 1.57226 13.2324 0.46489 2.31008 -10.6366 +614 2 13.6096 1.43937 12.4592 -18.9356 10.6634 16.2552 +615 2 12.412 2.34128 13.062 19.3329 -16.3736 -0.813643 +616 1 6.65189 13.7072 1.97939 -2.77776 -1.20266 13.9341 +617 2 6.01392 14.2112 2.53362 13.0928 -13.1372 -7.18637 +618 2 7.15166 13.1216 2.589 -8.8324 11.1791 -7.86511 +619 1 15.7768 6.33135 12.4394 -16.9523 -8.61752 -2.39927 +620 2 16.2545 6.83373 11.7966 11.5481 11.8457 -13.8092 +621 2 16.2346 6.49819 13.2509 8.584 1.06891 20.063 +622 1 16.7487 0.656157 9.53186 -1.89022 -32.3669 -10.6998 +623 2 16.6929 18.3191 9.69193 -1.14735 24.5709 0.588436 +624 2 16.3744 0.798362 8.64008 0.39513 1.76057 8.35052 +625 1 6.2256 11.6996 8.23382 -7.45249 -33.5883 4.29961 +626 2 5.41287 11.5766 8.79278 22.02 -5.73867 -21.2662 +627 2 6.53136 10.7979 7.88958 -15.1732 37.063 20.6987 +628 1 2.75779 8.608 0.340468 -48.3199 -4.33351 -7.97969 +629 2 2.08546 8.0585 18.4464 30.1073 27.602 24.3697 +630 2 2.23564 9.25518 0.892435 12.8354 -18.7139 -20.5564 +631 1 10.0773 10.2182 6.62419 2.67327 1.92209 4.62159 +632 2 10.5668 9.53044 7.10449 -1.07652 4.95909 -5.68289 +633 2 10.5655 10.3766 5.79827 -6.62323 -4.53969 7.46345 +634 1 6.84859 15.7294 6.8116 4.5172 -4.61086 -5.81045 +635 2 7.14728 16.2498 7.57791 -4.63192 -2.64256 -11.095 +636 2 7.17659 16.1616 6.00258 -4.95191 3.23702 9.76552 +637 1 6.62071 12.9207 5.93401 2.33655 2.8557 1.84805 +638 2 6.83452 13.8255 6.17261 -0.629609 6.79635 0.913528 +639 2 6.25462 12.5309 6.73716 -1.14115 0.401949 -5.14594 +640 1 16.7089 12.5339 9.77339 -0.869689 -1.39856 -8.71911 +641 2 16.7622 11.7819 9.15626 3.31473 10.0385 4.47785 +642 2 17.1611 13.2788 9.34464 -3.7572 -10.2702 6.17681 +643 1 6.29845 2.79213 2.75928 -3.20566 -14.4941 8.67087 +644 2 6.41489 3.68807 2.47435 5.42045 18.7619 -3.24562 +645 2 5.94058 2.32523 2.00482 -4.41542 -3.11109 -6.82659 +646 1 10.6289 2.95834 3.25769 -6.57134 8.8614 -3.08687 +647 2 10.3824 3.87829 3.42309 -0.834706 -5.50201 2.33367 +648 2 10.1446 2.71475 2.45701 2.51779 -3.35726 0.152255 diff --git a/examples/amoeba/dump.water_dimer.amoeba.1 b/examples/amoeba/dump.water_dimer.amoeba.1 new file mode 100644 index 0000000000..ec6d3eb2cd --- /dev/null +++ b/examples/amoeba/dump.water_dimer.amoeba.1 @@ -0,0 +1,165 @@ +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.024616 -0.001154 -0.003748 7.94661 0.0143882 11.5654 +2 2 -0.244211 -0.000666 0.933978 -7.05777 -0.00770443 -3.06431 +3 2 0.932234 -0.000406 -0.008705 -0.956334 -0.00629552 -7.87238 +4 1 -0.892721 0.00012 2.77367 -12.7377 -0.00815373 2.78728 +5 2 -1.463 0.75512 2.93387 6.39935 4.06267 -1.71086 +6 2 -1.46181 -0.755549 2.93493 6.40581 -4.05491 -1.70517 +ITEM: TIMESTEP +10 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0210901 -0.00114727 0.00187855 -6.1441 -0.00926688 -6.30688 +2 2 -0.299755 -0.000716119 0.924842 7.69349 0.00623407 0.274054 +3 2 0.933941 -0.000453269 -0.0777281 -1.08824 0.00357639 6.29137 +4 1 -0.89902 0.000115499 2.77431 8.40057 0.0041921 -3.3195 +5 2 -1.41411 0.797948 2.92323 -4.42685 -5.12343 1.53409 +6 2 -1.41285 -0.798315 2.92435 -4.43485 5.1187 1.52687 +ITEM: TIMESTEP +20 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0253162 -0.0011519 9.30621e-06 6.65721 0.0114207 8.7962 +2 2 -0.214112 -0.000636438 0.94263 -7.71284 -0.00678668 -1.03908 +3 2 0.928921 -0.000430955 -0.0404651 0.717191 -0.00462784 -7.37266 +4 1 -0.894334 0.00011596 2.76974 -10.0965 -0.00568803 3.16137 +5 2 -1.45804 0.75449 2.94684 5.21348 5.11475 -1.77652 +6 2 -1.45685 -0.754893 2.9479 5.22149 -5.10907 -1.76931 +ITEM: TIMESTEP +30 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0221554 -0.0011439 0.00783939 -8.36895 -0.0130834 -9.24354 +2 2 -0.25261 -0.000667783 0.941075 6.36112 0.00692164 2.73081 +3 2 0.92432 -0.000494304 -0.125343 2.07038 0.00615069 6.42537 +4 1 -0.900866 0.00010992 2.76846 11.0986 0.00640696 -3.42785 +5 2 -1.40977 0.795072 2.93807 -5.57817 -3.04583 1.75974 +6 2 -1.40852 -0.795411 2.93919 -5.58301 3.03943 1.75548 +ITEM: TIMESTEP +40 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0269208 -0.00114842 0.00674288 5.42877 0.00730481 4.31748 +2 2 -0.171607 -0.000594964 0.954009 -8.40692 -0.00484075 2.50346 +3 2 0.92209 -0.000466908 -0.0840066 2.3456 -0.00296432 -6.82561 +4 1 -0.895716 0.000110956 2.76419 -6.18264 -0.00259137 3.07323 +5 2 -1.45218 0.754436 2.95353 3.40261 6.39649 -1.53879 +6 2 -1.45099 -0.75482 2.9546 3.41259 -6.3934 -1.52976 +ITEM: TIMESTEP +50 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0239329 -0.00114175 0.0128926 -8.15007 -0.014184 -11.0504 +2 2 -0.230937 -0.000644481 0.949766 5.72493 0.00756591 4.36142 +3 2 0.91871 -0.000511822 -0.144074 2.40885 0.00639366 6.3907 +4 1 -0.899724 0.000108594 2.76531 11.5106 0.00694105 -3.03119 +5 2 -1.41275 0.792848 2.92798 -5.74551 -2.08247 1.6662 +6 2 -1.41151 -0.793206 2.9291 -5.7488 2.07576 1.66327 +ITEM: TIMESTEP +60 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0287434 -0.0011479 0.00953424 6.82379 0.00862743 4.63675 +2 2 -0.180318 -0.000600308 0.956082 -8.03241 -0.00482631 2.10983 +3 2 0.922397 -0.000459471 -0.0739414 0.782565 -0.00412295 -6.72684 +4 1 -0.892694 0.000113827 2.76489 -6.55004 -0.00361317 2.26756 +5 2 -1.45749 0.757284 2.91975 3.48398 5.14308 -1.14726 +6 2 -1.4563 -0.757724 2.92081 3.49211 -5.13915 -1.14003 +ITEM: TIMESTEP +70 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.025848 -0.00114271 0.0136758 -6.10179 -0.0106002 -8.24377 +2 2 -0.259382 -0.000669072 0.94681 6.59121 0.0065405 1.93161 +3 2 0.923692 -0.000484045 -0.110366 -0.0484081 0.00428029 6.1322 +4 1 -0.894893 0.000114175 2.76783 7.43985 0.00424265 -2.1131 +5 2 -1.42416 0.79251 2.88639 -3.9377 -3.53776 1.14903 +6 2 -1.42292 -0.792944 2.88751 -3.94318 3.53329 1.14403 +ITEM: TIMESTEP +80 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.030135 -0.00114891 0.00965506 7.41429 0.0123912 9.3266 +2 2 -0.213346 -0.000627628 0.954378 -6.76672 -0.00675668 -2.04974 +3 2 0.924938 -0.000432456 -0.0385785 -0.591495 -0.00546702 -7.10385 +4 1 -0.888796 0.000119275 2.76827 -9.03539 -0.00642914 1.05959 +5 2 -1.46214 0.762697 2.87512 4.48797 2.10983 -0.617778 +6 2 -1.46094 -0.763208 2.87619 4.49133 -2.10357 -0.61482 +ITEM: TIMESTEP +90 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0270206 -0.00114299 0.0145983 -6.11813 -0.00811207 -4.69194 +2 2 -0.274281 -0.000680382 0.947366 7.50569 0.00503125 -1.23144 +3 2 0.92514 -0.000469353 -0.0912836 -0.650877 0.00352314 5.72916 +4 1 -0.891964 0.000116952 2.76852 3.17186 0.0014363 -1.52231 +5 2 -1.43137 0.791127 2.86377 -1.95059 -4.67792 0.861555 +6 2 -1.43013 -0.791605 2.86488 -1.95795 4.67604 0.85497 +ITEM: TIMESTEP +100 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.030669 -0.00114759 0.0121427 6.42493 0.0120997 10.0073 +2 2 -0.203569 -0.000615753 0.960107 -6.40597 -0.00736639 -3.30674 +3 2 0.923036 -0.000442107 -0.0503324 -0.0528607 -0.00477186 -6.71539 +4 1 -0.889443 0.000116814 2.76553 -7.7691 -0.0050422 1.37075 +5 2 -1.45671 0.76736 2.88018 3.9012 0.426437 -0.678284 +6 2 -1.4555 -0.767854 2.88126 3.9018 -0.421357 -0.677675 diff --git a/examples/amoeba/dump.water_dimer.amoeba.4 b/examples/amoeba/dump.water_dimer.amoeba.4 new file mode 100644 index 0000000000..ec6d3eb2cd --- /dev/null +++ b/examples/amoeba/dump.water_dimer.amoeba.4 @@ -0,0 +1,165 @@ +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.024616 -0.001154 -0.003748 7.94661 0.0143882 11.5654 +2 2 -0.244211 -0.000666 0.933978 -7.05777 -0.00770443 -3.06431 +3 2 0.932234 -0.000406 -0.008705 -0.956334 -0.00629552 -7.87238 +4 1 -0.892721 0.00012 2.77367 -12.7377 -0.00815373 2.78728 +5 2 -1.463 0.75512 2.93387 6.39935 4.06267 -1.71086 +6 2 -1.46181 -0.755549 2.93493 6.40581 -4.05491 -1.70517 +ITEM: TIMESTEP +10 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0210901 -0.00114727 0.00187855 -6.1441 -0.00926688 -6.30688 +2 2 -0.299755 -0.000716119 0.924842 7.69349 0.00623407 0.274054 +3 2 0.933941 -0.000453269 -0.0777281 -1.08824 0.00357639 6.29137 +4 1 -0.89902 0.000115499 2.77431 8.40057 0.0041921 -3.3195 +5 2 -1.41411 0.797948 2.92323 -4.42685 -5.12343 1.53409 +6 2 -1.41285 -0.798315 2.92435 -4.43485 5.1187 1.52687 +ITEM: TIMESTEP +20 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0253162 -0.0011519 9.30621e-06 6.65721 0.0114207 8.7962 +2 2 -0.214112 -0.000636438 0.94263 -7.71284 -0.00678668 -1.03908 +3 2 0.928921 -0.000430955 -0.0404651 0.717191 -0.00462784 -7.37266 +4 1 -0.894334 0.00011596 2.76974 -10.0965 -0.00568803 3.16137 +5 2 -1.45804 0.75449 2.94684 5.21348 5.11475 -1.77652 +6 2 -1.45685 -0.754893 2.9479 5.22149 -5.10907 -1.76931 +ITEM: TIMESTEP +30 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0221554 -0.0011439 0.00783939 -8.36895 -0.0130834 -9.24354 +2 2 -0.25261 -0.000667783 0.941075 6.36112 0.00692164 2.73081 +3 2 0.92432 -0.000494304 -0.125343 2.07038 0.00615069 6.42537 +4 1 -0.900866 0.00010992 2.76846 11.0986 0.00640696 -3.42785 +5 2 -1.40977 0.795072 2.93807 -5.57817 -3.04583 1.75974 +6 2 -1.40852 -0.795411 2.93919 -5.58301 3.03943 1.75548 +ITEM: TIMESTEP +40 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0269208 -0.00114842 0.00674288 5.42877 0.00730481 4.31748 +2 2 -0.171607 -0.000594964 0.954009 -8.40692 -0.00484075 2.50346 +3 2 0.92209 -0.000466908 -0.0840066 2.3456 -0.00296432 -6.82561 +4 1 -0.895716 0.000110956 2.76419 -6.18264 -0.00259137 3.07323 +5 2 -1.45218 0.754436 2.95353 3.40261 6.39649 -1.53879 +6 2 -1.45099 -0.75482 2.9546 3.41259 -6.3934 -1.52976 +ITEM: TIMESTEP +50 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0239329 -0.00114175 0.0128926 -8.15007 -0.014184 -11.0504 +2 2 -0.230937 -0.000644481 0.949766 5.72493 0.00756591 4.36142 +3 2 0.91871 -0.000511822 -0.144074 2.40885 0.00639366 6.3907 +4 1 -0.899724 0.000108594 2.76531 11.5106 0.00694105 -3.03119 +5 2 -1.41275 0.792848 2.92798 -5.74551 -2.08247 1.6662 +6 2 -1.41151 -0.793206 2.9291 -5.7488 2.07576 1.66327 +ITEM: TIMESTEP +60 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0287434 -0.0011479 0.00953424 6.82379 0.00862743 4.63675 +2 2 -0.180318 -0.000600308 0.956082 -8.03241 -0.00482631 2.10983 +3 2 0.922397 -0.000459471 -0.0739414 0.782565 -0.00412295 -6.72684 +4 1 -0.892694 0.000113827 2.76489 -6.55004 -0.00361317 2.26756 +5 2 -1.45749 0.757284 2.91975 3.48398 5.14308 -1.14726 +6 2 -1.4563 -0.757724 2.92081 3.49211 -5.13915 -1.14003 +ITEM: TIMESTEP +70 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.025848 -0.00114271 0.0136758 -6.10179 -0.0106002 -8.24377 +2 2 -0.259382 -0.000669072 0.94681 6.59121 0.0065405 1.93161 +3 2 0.923692 -0.000484045 -0.110366 -0.0484081 0.00428029 6.1322 +4 1 -0.894893 0.000114175 2.76783 7.43985 0.00424265 -2.1131 +5 2 -1.42416 0.79251 2.88639 -3.9377 -3.53776 1.14903 +6 2 -1.42292 -0.792944 2.88751 -3.94318 3.53329 1.14403 +ITEM: TIMESTEP +80 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.030135 -0.00114891 0.00965506 7.41429 0.0123912 9.3266 +2 2 -0.213346 -0.000627628 0.954378 -6.76672 -0.00675668 -2.04974 +3 2 0.924938 -0.000432456 -0.0385785 -0.591495 -0.00546702 -7.10385 +4 1 -0.888796 0.000119275 2.76827 -9.03539 -0.00642914 1.05959 +5 2 -1.46214 0.762697 2.87512 4.48797 2.10983 -0.617778 +6 2 -1.46094 -0.763208 2.87619 4.49133 -2.10357 -0.61482 +ITEM: TIMESTEP +90 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0270206 -0.00114299 0.0145983 -6.11813 -0.00811207 -4.69194 +2 2 -0.274281 -0.000680382 0.947366 7.50569 0.00503125 -1.23144 +3 2 0.92514 -0.000469353 -0.0912836 -0.650877 0.00352314 5.72916 +4 1 -0.891964 0.000116952 2.76852 3.17186 0.0014363 -1.52231 +5 2 -1.43137 0.791127 2.86377 -1.95059 -4.67792 0.861555 +6 2 -1.43013 -0.791605 2.86488 -1.95795 4.67604 0.85497 +ITEM: TIMESTEP +100 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.030669 -0.00114759 0.0121427 6.42493 0.0120997 10.0073 +2 2 -0.203569 -0.000615753 0.960107 -6.40597 -0.00736639 -3.30674 +3 2 0.923036 -0.000442107 -0.0503324 -0.0528607 -0.00477186 -6.71539 +4 1 -0.889443 0.000116814 2.76553 -7.7691 -0.0050422 1.37075 +5 2 -1.45671 0.76736 2.88018 3.9012 0.426437 -0.678284 +6 2 -1.4555 -0.767854 2.88126 3.9018 -0.421357 -0.677675 diff --git a/examples/amoeba/dump.water_dimer.hippo.1 b/examples/amoeba/dump.water_dimer.hippo.1 new file mode 100644 index 0000000000..854055cac8 --- /dev/null +++ b/examples/amoeba/dump.water_dimer.hippo.1 @@ -0,0 +1,165 @@ +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.024616 -0.001154 -0.003748 6.77815 0.012441 10.1043 +2 2 -0.244211 -0.000666 0.933978 -6.4757 -0.0067894 -2.41462 +3 2 0.932234 -0.000406 -0.008705 -0.41382 -0.00540908 -7.21892 +4 1 -0.892721 0.00012 2.77367 -11.9286 -0.00716387 3.29032 +5 2 -1.463 0.75512 2.93387 6.01759 3.00398 -1.88265 +6 2 -1.46181 -0.755549 2.93493 6.02238 -2.99706 -1.87845 +ITEM: TIMESTEP +10 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0215682 -0.00114805 0.0012979 -6.21268 -0.00924301 -6.19628 +2 2 -0.293095 -0.000710409 0.925512 6.99875 0.0060121 0.73377 +3 2 0.933101 -0.000449223 -0.0710512 -0.501529 0.00371221 5.82975 +4 1 -0.897884 0.000116793 2.77488 7.53966 0.00410482 -2.48587 +5 2 -1.42223 0.790989 2.91963 -3.9083 -4.87571 1.06275 +6 2 -1.42099 -0.791374 2.92075 -3.91591 4.87112 1.05588 +ITEM: TIMESTEP +20 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0258564 -0.00115245 -0.000173159 6.03126 0.0103631 7.9915 +2 2 -0.214264 -0.000636469 0.942735 -7.00136 -0.00592601 -0.60904 +3 2 0.929001 -0.000430037 -0.0392653 0.701856 -0.0043552 -6.96821 +4 1 -0.893054 0.000118973 2.77259 -8.83712 -0.00512625 2.54445 +5 2 -1.46387 0.753541 2.92502 4.54888 4.85296 -1.48277 +6 2 -1.46268 -0.753984 2.92608 4.55648 -4.84791 -1.47593 +ITEM: TIMESTEP +30 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0237238 -0.00114526 0.00766999 -7.81865 -0.0119879 -8.3015 +2 2 -0.241061 -0.000656856 0.943727 6.09288 0.0066852 2.69388 +3 2 0.923032 -0.000493736 -0.123121 1.75879 0.00552582 5.88556 +4 1 -0.897978 0.000115451 2.77309 11.6501 0.00727223 -2.82116 +5 2 -1.42536 0.788259 2.90023 -5.83991 -2.07218 1.27305 +6 2 -1.42412 -0.788676 2.90134 -5.84324 2.06468 1.27016 +ITEM: TIMESTEP +40 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0292005 -0.00114894 0.00855106 5.6712 0.00787804 4.86214 +2 2 -0.153199 -0.000576377 0.959922 -7.58451 -0.00449199 2.07976 +3 2 0.919336 -0.000480028 -0.0995905 1.37912 -0.00359093 -6.63778 +4 1 -0.89217 0.000118771 2.77132 -5.68638 -0.00321013 1.64962 +5 2 -1.47004 0.751887 2.88738 3.10503 6.73714 -0.981624 +6 2 -1.46886 -0.752392 2.88844 3.11554 -6.73373 -0.972121 +ITEM: TIMESTEP +50 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0276682 -0.00114169 0.0171537 -7.90829 -0.012452 -8.85967 +2 2 -0.185755 -0.000598779 0.964286 5.83022 0.00671605 3.0354 +3 2 0.908646 -0.000541992 -0.175729 1.96931 0.00577867 6.00768 +4 1 -0.895573 0.00011689 2.77245 11.8261 0.00822001 -1.54401 +5 2 -1.4336 0.787999 2.84603 -5.85703 -2.08185 0.681764 +6 2 -1.43237 -0.788505 2.84714 -5.86031 2.07358 0.678838 +ITEM: TIMESTEP +60 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0340777 -0.00114581 0.0184647 7.2272 0.00951667 5.4479 +2 2 -0.113434 -0.000533921 0.975674 -7.44659 -0.00496006 1.26816 +3 2 0.909471 -0.000512535 -0.134923 -0.287426 -0.00476073 -6.43846 +4 1 -0.888126 0.000122907 2.77269 -9.08281 -0.00670232 0.725333 +5 2 -1.47838 0.753365 2.8077 4.79099 4.82306 -0.504859 +6 2 -1.47719 -0.753996 2.80876 4.79863 -4.81616 -0.498076 +ITEM: TIMESTEP +70 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0329631 -0.00113896 0.0269437 -6.82209 -0.00981599 -6.32682 +2 2 -0.16378 -0.000570078 0.980622 6.44654 0.00529861 0.332147 +3 2 0.899135 -0.000560623 -0.191768 0.56204 0.00474764 6.11404 +4 1 -0.890774 0.0001215 2.77364 7.6207 0.00561833 -0.364449 +5 2 -1.4359 0.790393 2.75878 -3.89983 -4.84574 0.12595 +6 2 -1.43466 -0.791026 2.7599 -3.90736 4.83989 0.11913 +ITEM: TIMESTEP +80 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0396799 -0.00114299 0.0287108 8.10782 0.0121934 8.26954 +2 2 -0.101327 -0.000514632 0.989821 -6.98655 -0.00644087 -1.35375 +3 2 0.902079 -0.000521504 -0.139604 -1.23495 -0.0056704 -6.67396 +4 1 -0.883488 0.000127321 2.77377 -12.2256 -0.0109573 -1.83848 +5 2 -1.47309 0.755263 2.71301 6.16734 2.89071 0.796293 +6 2 -1.4719 -0.756019 2.71407 6.17192 -2.87983 0.800362 +ITEM: TIMESTEP +90 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0383179 -0.00113532 0.0380883 -7.16334 -0.00889532 -4.6369 +2 2 -0.149498 -0.00054848 0.995531 6.83221 0.00448143 -1.26419 +3 2 0.889431 -0.00057205 -0.197356 0.916 0.00477871 5.76452 +4 1 -0.886952 0.000122589 2.77093 7.29365 0.00587785 0.155791 +5 2 -1.42602 0.790491 2.68716 -3.93543 -4.86013 -0.00619146 +6 2 -1.42478 -0.791209 2.68827 -3.94309 4.85389 -0.0130349 +ITEM: TIMESTEP +100 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0443853 -0.00113803 0.0410221 7.36858 0.0108291 7.15279 +2 2 -0.076648 -0.000485983 1.00287 -6.96363 -0.00585609 -0.543819 +3 2 0.890615 -0.000542732 -0.157107 -0.3904 -0.00504823 -6.73186 +4 1 -0.880834 0.000124898 2.7674 -9.13947 -0.00841726 -1.90715 +5 2 -1.46341 0.754149 2.66816 4.55895 4.52404 1.01184 +6 2 -1.46222 -0.754952 2.66922 4.56597 -4.51554 1.01819 diff --git a/examples/amoeba/dump.water_dimer.hippo.4 b/examples/amoeba/dump.water_dimer.hippo.4 new file mode 100644 index 0000000000..854055cac8 --- /dev/null +++ b/examples/amoeba/dump.water_dimer.hippo.4 @@ -0,0 +1,165 @@ +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.024616 -0.001154 -0.003748 6.77815 0.012441 10.1043 +2 2 -0.244211 -0.000666 0.933978 -6.4757 -0.0067894 -2.41462 +3 2 0.932234 -0.000406 -0.008705 -0.41382 -0.00540908 -7.21892 +4 1 -0.892721 0.00012 2.77367 -11.9286 -0.00716387 3.29032 +5 2 -1.463 0.75512 2.93387 6.01759 3.00398 -1.88265 +6 2 -1.46181 -0.755549 2.93493 6.02238 -2.99706 -1.87845 +ITEM: TIMESTEP +10 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0215682 -0.00114805 0.0012979 -6.21268 -0.00924301 -6.19628 +2 2 -0.293095 -0.000710409 0.925512 6.99875 0.0060121 0.73377 +3 2 0.933101 -0.000449223 -0.0710512 -0.501529 0.00371221 5.82975 +4 1 -0.897884 0.000116793 2.77488 7.53966 0.00410482 -2.48587 +5 2 -1.42223 0.790989 2.91963 -3.9083 -4.87571 1.06275 +6 2 -1.42099 -0.791374 2.92075 -3.91591 4.87112 1.05588 +ITEM: TIMESTEP +20 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0258564 -0.00115245 -0.000173159 6.03126 0.0103631 7.9915 +2 2 -0.214264 -0.000636469 0.942735 -7.00136 -0.00592601 -0.60904 +3 2 0.929001 -0.000430037 -0.0392653 0.701856 -0.0043552 -6.96821 +4 1 -0.893054 0.000118973 2.77259 -8.83712 -0.00512625 2.54445 +5 2 -1.46387 0.753541 2.92502 4.54888 4.85296 -1.48277 +6 2 -1.46268 -0.753984 2.92608 4.55648 -4.84791 -1.47593 +ITEM: TIMESTEP +30 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0237238 -0.00114526 0.00766999 -7.81865 -0.0119879 -8.3015 +2 2 -0.241061 -0.000656856 0.943727 6.09288 0.0066852 2.69388 +3 2 0.923032 -0.000493736 -0.123121 1.75879 0.00552582 5.88556 +4 1 -0.897978 0.000115451 2.77309 11.6501 0.00727223 -2.82116 +5 2 -1.42536 0.788259 2.90023 -5.83991 -2.07218 1.27305 +6 2 -1.42412 -0.788676 2.90134 -5.84324 2.06468 1.27016 +ITEM: TIMESTEP +40 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0292005 -0.00114894 0.00855106 5.6712 0.00787804 4.86214 +2 2 -0.153199 -0.000576377 0.959922 -7.58451 -0.00449199 2.07976 +3 2 0.919336 -0.000480028 -0.0995905 1.37912 -0.00359093 -6.63778 +4 1 -0.89217 0.000118771 2.77132 -5.68638 -0.00321013 1.64962 +5 2 -1.47004 0.751887 2.88738 3.10503 6.73714 -0.981624 +6 2 -1.46886 -0.752392 2.88844 3.11554 -6.73373 -0.972121 +ITEM: TIMESTEP +50 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0276682 -0.00114169 0.0171537 -7.90829 -0.012452 -8.85967 +2 2 -0.185755 -0.000598779 0.964286 5.83022 0.00671605 3.0354 +3 2 0.908646 -0.000541992 -0.175729 1.96931 0.00577867 6.00768 +4 1 -0.895573 0.00011689 2.77245 11.8261 0.00822001 -1.54401 +5 2 -1.4336 0.787999 2.84603 -5.85703 -2.08185 0.681764 +6 2 -1.43237 -0.788505 2.84714 -5.86031 2.07358 0.678838 +ITEM: TIMESTEP +60 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0340777 -0.00114581 0.0184647 7.2272 0.00951667 5.4479 +2 2 -0.113434 -0.000533921 0.975674 -7.44659 -0.00496006 1.26816 +3 2 0.909471 -0.000512535 -0.134923 -0.287426 -0.00476073 -6.43846 +4 1 -0.888126 0.000122907 2.77269 -9.08281 -0.00670232 0.725333 +5 2 -1.47838 0.753365 2.8077 4.79099 4.82306 -0.504859 +6 2 -1.47719 -0.753996 2.80876 4.79863 -4.81616 -0.498076 +ITEM: TIMESTEP +70 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0329631 -0.00113896 0.0269437 -6.82209 -0.00981599 -6.32682 +2 2 -0.16378 -0.000570078 0.980622 6.44654 0.00529861 0.332147 +3 2 0.899135 -0.000560623 -0.191768 0.56204 0.00474764 6.11404 +4 1 -0.890774 0.0001215 2.77364 7.6207 0.00561833 -0.364449 +5 2 -1.4359 0.790393 2.75878 -3.89983 -4.84574 0.12595 +6 2 -1.43466 -0.791026 2.7599 -3.90736 4.83989 0.11913 +ITEM: TIMESTEP +80 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0396799 -0.00114299 0.0287108 8.10782 0.0121934 8.26954 +2 2 -0.101327 -0.000514632 0.989821 -6.98655 -0.00644087 -1.35375 +3 2 0.902079 -0.000521504 -0.139604 -1.23495 -0.0056704 -6.67396 +4 1 -0.883488 0.000127321 2.77377 -12.2256 -0.0109573 -1.83848 +5 2 -1.47309 0.755263 2.71301 6.16734 2.89071 0.796293 +6 2 -1.4719 -0.756019 2.71407 6.17192 -2.87983 0.800362 +ITEM: TIMESTEP +90 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0383179 -0.00113532 0.0380883 -7.16334 -0.00889532 -4.6369 +2 2 -0.149498 -0.00054848 0.995531 6.83221 0.00448143 -1.26419 +3 2 0.889431 -0.00057205 -0.197356 0.916 0.00477871 5.76452 +4 1 -0.886952 0.000122589 2.77093 7.29365 0.00587785 0.155791 +5 2 -1.42602 0.790491 2.68716 -3.93543 -4.86013 -0.00619146 +6 2 -1.42478 -0.791209 2.68827 -3.94309 4.85389 -0.0130349 +ITEM: TIMESTEP +100 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0443853 -0.00113803 0.0410221 7.36858 0.0108291 7.15279 +2 2 -0.076648 -0.000485983 1.00287 -6.96363 -0.00585609 -0.543819 +3 2 0.890615 -0.000542732 -0.157107 -0.3904 -0.00504823 -6.73186 +4 1 -0.880834 0.000124898 2.7674 -9.13947 -0.00841726 -1.90715 +5 2 -1.46341 0.754149 2.66816 4.55895 4.52404 1.01184 +6 2 -1.46222 -0.754952 2.66922 4.56597 -4.51554 1.01819 diff --git a/examples/amoeba/dump.water_hexamer.amoeba.1 b/examples/amoeba/dump.water_hexamer.amoeba.1 new file mode 100644 index 0000000000..88e888cc45 --- /dev/null +++ b/examples/amoeba/dump.water_hexamer.amoeba.1 @@ -0,0 +1,297 @@ +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.50217 -0.191359 1.43493 15.8836 -7.45837 3.84323 +2 2 -0.601054 -0.596972 1.55372 -22.9153 9.01978 -0.990133 +3 2 -2.0067 -0.422327 2.21985 1.01155 0.118537 -0.791932 +4 1 -1.74457 -0.382348 -1.30914 -6.66041 -3.92202 8.41554 +5 2 -1.88894 -0.479653 -0.347624 4.77968 3.15053 -8.64245 +6 2 -2.51683 -0.766765 -1.73377 2.90782 1.57916 -0.744558 +7 1 -0.560409 2.01783 -0.121984 -13.2194 -12.8195 1.43178 +8 2 -0.94772 1.53357 0.625228 6.08473 6.021 -1.58068 +9 2 -0.989831 1.59274 -0.877419 5.83415 5.52991 -0.337029 +10 1 0.964803 -1.16576 1.43999 12.6547 2.88136 -21.3636 +11 2 0.979557 -1.52204 0.527833 -3.6968 -1.92725 12.6575 +12 2 1.54222 -0.393692 1.34437 -3.37883 -2.73031 5.998 +13 1 0.974705 -1.4015 -1.33597 -6.12193 14.8514 -0.790538 +14 2 0.065161 -1.11895 -1.52289 4.56017 -6.05436 1.71545 +15 2 1.47071 -0.570933 -1.27771 1.31912 -7.40942 1.06098 +16 1 2.00228 1.05782 -0.124502 -10.3736 10.8414 -1.12005 +17 2 1.14164 1.53227 -0.140121 11.8812 -8.20067 0.772116 +18 2 2.67472 1.73534 -0.237995 -0.550493 -3.47117 0.466398 +ITEM: TIMESTEP +10 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.50661 -0.189383 1.4364 14.5938 -8.99605 8.72579 +2 2 -0.616993 -0.604745 1.5716 -17.7352 9.03346 -4.01613 +3 2 -2.01184 -0.421588 2.22126 -0.664878 1.39015 -2.52743 +4 1 -1.74564 -0.383429 -1.31051 0.451442 -0.432875 3.71075 +5 2 -1.85676 -0.451272 -0.342641 -1.17801 0.27861 -9.12816 +6 2 -2.51648 -0.764704 -1.74119 1.00433 0.523826 3.94489 +7 1 -0.565581 2.01415 -0.121947 -0.431671 0.816258 1.37224 +8 2 -0.923503 1.54613 0.649943 -0.836345 -0.35076 -8.91816 +9 2 -0.954982 1.61593 -0.9136 -0.398984 -1.29665 6.9827 +10 1 0.971315 -1.16462 1.43403 2.66632 -4.10463 -4.1745 +11 2 0.960388 -1.57587 0.54557 3.80791 8.56867 8.0783 +12 2 1.545 -0.38505 1.37422 -2.3984 -5.62816 -5.66197 +13 1 0.972827 -1.39712 -1.33549 -1.10638 0.442925 0.267527 +14 2 0.0526434 -1.14464 -1.51395 7.06933 2.8298 1.48943 +15 2 1.50554 -0.590868 -1.25662 -6.54392 -2.53639 -0.258333 +16 1 2.00275 1.0584 -0.124848 -7.13185 5.38221 -0.0306111 +17 2 1.13969 1.52381 -0.134074 11.7308 -4.5992 -0.113372 +18 2 2.68869 1.72277 -0.237084 -2.89819 -1.32119 0.257039 +ITEM: TIMESTEP +20 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.51649 -0.18584 1.44395 5.65501 -4.20149 4.07802 +2 2 -0.637196 -0.60535 1.5789 -10.2535 4.51311 -0.350867 +3 2 -2.05196 -0.408647 2.21473 3.52072 0.575858 -3.20585 +4 1 -1.74216 -0.383007 -1.31779 -5.65244 -1.7459 7.46957 +5 2 -1.85838 -0.422286 -0.35262 3.57624 0.698487 -5.03248 +6 2 -2.53778 -0.772973 -1.68856 2.62304 1.05785 -2.46299 +7 1 -0.568621 2.01502 -0.121788 -7.49291 -10.5083 -0.07078 +8 2 -0.953332 1.50031 0.601729 3.90339 5.1027 1.32659 +9 2 -0.948304 1.59097 -0.90055 3.2198 4.86429 -1.5712 +10 1 0.981527 -1.16776 1.43139 8.19382 2.30469 -14.0571 +11 2 0.999682 -1.57682 0.548153 -4.17545 -1.46604 7.90595 +12 2 1.55686 -0.401102 1.29785 -3.41945 -1.35828 5.31582 +13 1 0.971997 -1.39727 -1.33295 -3.50737 11.1512 0.685267 +14 2 0.0679408 -1.0929 -1.49373 1.59713 -5.72522 -0.144088 +15 2 1.47933 -0.582056 -1.22295 2.04209 -4.76253 -0.234646 +16 1 2.00557 1.05551 -0.12468 -4.4992 7.40197 -0.448564 +17 2 1.16008 1.5422 -0.129327 5.1837 -4.83397 0.46283 +18 2 2.69054 1.72007 -0.238059 -0.51465 -3.06849 0.334482 +ITEM: TIMESTEP +30 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.52872 -0.18011 1.45173 -0.933277 -2.21949 5.98424 +2 2 -0.665459 -0.602256 1.60472 0.633036 0.719099 -1.22127 +3 2 -2.07366 -0.404666 2.21589 2.60377 1.4581 -4.42661 +4 1 -1.74225 -0.382648 -1.3226 2.4731 1.57235 -0.799694 +5 2 -1.81423 -0.398932 -0.35676 -3.06045 -1.92828 -1.63228 +6 2 -2.5352 -0.77665 -1.69294 0.0233925 -0.139311 2.03217 +7 1 -0.576286 2.0073 -0.122823 5.68391 5.42307 0.543301 +8 2 -0.95235 1.50691 0.611905 -2.48677 -2.29116 -3.6455 +9 2 -0.915502 1.63076 -0.941481 -3.12923 -3.02599 2.90572 +10 1 0.998541 -1.16996 1.42191 -2.76709 -0.0175982 4.85417 +11 2 0.970261 -1.63876 0.575717 2.4618 4.28015 -0.493825 +12 2 1.54742 -0.386783 1.27666 -1.41861 -3.70889 -3.67396 +13 1 0.969317 -1.3895 -1.32829 2.03562 -5.48364 0.295138 +14 2 0.0583035 -1.11723 -1.49206 1.73159 3.49229 -0.0543931 +15 2 1.50655 -0.600283 -1.19205 -3.9925 1.94925 -1.04523 +16 1 2.00848 1.05446 -0.124132 1.88868 -1.58075 0.754117 +17 2 1.16959 1.53865 -0.11771 0.573913 1.34283 -0.58573 +18 2 2.71517 1.69464 -0.239075 -2.32089 0.157967 0.209615 +ITEM: TIMESTEP +40 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.53726 -0.175397 1.46121 -7.56641 2.45844 -0.518817 +2 2 -0.675238 -0.584022 1.60915 7.85196 -3.99237 1.67217 +3 2 -2.08862 -0.402087 2.21789 3.0617 0.39778 -2.04562 +4 1 -1.73949 -0.379604 -1.32819 -2.36016 -0.787528 -0.0315325 +5 2 -1.83346 -0.428429 -0.37056 1.90026 0.717301 4.17358 +6 2 -2.53017 -0.786871 -1.68316 0.151557 -0.108901 -3.75615 +7 1 -0.576955 2.0043 -0.124416 -0.431513 -1.54355 -1.46354 +8 2 -0.992092 1.48382 0.567817 1.09284 0.418387 6.78235 +9 2 -0.944746 1.62819 -0.925975 0.76441 1.37882 -5.22407 +10 1 1.00941 -1.17308 1.4189 -1.85973 4.64458 1.0889 +11 2 0.973659 -1.6403 0.580693 -1.69219 -4.78957 -3.29195 +12 2 1.53559 -0.396477 1.19908 0.544307 1.46508 3.63166 +13 1 0.969009 -1.38744 -1.3228 -0.275569 1.85307 -0.63583 +14 2 0.0737932 -1.09141 -1.50366 -4.66851 -2.83882 -1.16892 +15 2 1.46633 -0.576681 -1.19175 5.00795 0.70617 0.521536 +16 1 2.01183 1.05054 -0.121932 4.41526 -1.70685 -0.0836272 +17 2 1.19121 1.55327 -0.120038 -7.25224 2.19125 0.154184 +18 2 2.71636 1.68982 -0.237383 1.31607 -0.463304 0.195666 +ITEM: TIMESTEP +50 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.53986 -0.172749 1.46865 -10.3641 5.96951 -4.41562 +2 2 -0.678724 -0.568486 1.60775 14.9207 -7.13278 2.04782 +3 2 -2.07217 -0.405364 2.23045 -0.725799 -0.490948 1.77161 +4 1 -1.74113 -0.378171 -1.32957 5.99712 2.85952 -9.13842 +5 2 -1.82713 -0.447378 -0.375703 -3.89226 -1.3818 7.11516 +6 2 -2.4999 -0.790471 -1.74187 -3.02333 -1.60416 1.77146 +7 1 -0.579496 1.99691 -0.128028 9.72738 10.7655 -0.463519 +8 2 -0.97832 1.50522 0.591572 -4.4866 -5.64841 2.33138 +9 2 -0.951447 1.66071 -0.944057 -3.97244 -4.92262 -1.79974 +10 1 1.01358 -1.17192 1.41393 -6.48605 2.83151 13.495 +11 2 0.960671 -1.668 0.598799 0.887838 -3.18341 -9.75086 +12 2 1.53449 -0.394669 1.19537 2.46945 2.14925 -1.89795 +13 1 0.966791 -1.38037 -1.31946 4.73561 -12.449 -1.17286 +14 2 0.0653014 -1.12956 -1.52441 -4.76491 5.51904 -0.304595 +15 2 1.48076 -0.580834 -1.19775 0.0522693 6.36707 0.249418 +16 1 2.01309 1.04924 -0.119438 7.79557 -11.0594 0.778107 +17 2 1.18753 1.53519 -0.124654 -9.57007 7.63584 -0.456674 +18 2 2.72824 1.67508 -0.226016 0.699647 3.77524 -0.159727 +ITEM: TIMESTEP +60 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.535 -0.173529 1.47468 -12.8115 9.37187 -10.8344 +2 2 -0.673508 -0.564245 1.59147 19.3914 -9.12777 2.73797 +3 2 -2.04099 -0.404174 2.24807 -3.82175 -1.70255 6.71674 +4 1 -1.73996 -0.376347 -1.33351 0.570165 0.280665 -6.43548 +5 2 -1.87928 -0.466718 -0.390362 1.26398 0.876645 10.7815 +6 2 -2.48657 -0.801116 -1.75201 -2.14828 -1.00411 -3.66812 +7 1 -0.576718 1.99595 -0.131852 3.14419 3.30092 -1.47913 +8 2 -0.97416 1.49195 0.577492 -1.32391 -2.58987 8.72867 +9 2 -0.983297 1.63168 -0.91691 -0.334419 -0.770035 -7.07098 +10 1 1.00791 -1.1681 1.41401 -6.20027 1.07549 12.575 +11 2 0.972875 -1.65454 0.593802 -0.476084 -5.46772 -10.3478 +12 2 1.54632 -0.404877 1.20306 3.83119 5.88484 -0.834958 +13 1 0.966385 -1.38017 -1.32091 1.49436 -4.60495 -1.57148 +14 2 0.0722824 -1.10128 -1.51274 -8.16812 -0.531008 -1.13308 +15 2 1.45394 -0.565765 -1.20718 7.01226 4.42564 1.66198 +16 1 2.01308 1.04537 -0.116618 6.94232 -7.944 0.350248 +17 2 1.19126 1.53332 -0.135036 -13.3157 5.74475 0.221956 +18 2 2.70715 1.69348 -0.205764 4.95008 2.7812 -0.398561 +ITEM: TIMESTEP +70 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.52447 -0.177745 1.47754 -14.009 12.5988 -14.9127 +2 2 -0.663619 -0.56979 1.57126 20.9018 -10.2143 3.8986 +3 2 -2.00537 -0.388653 2.26816 -5.41735 -2.91391 10.0958 +4 1 -1.74327 -0.377755 -1.33511 7.69657 4.1782 -9.73798 +5 2 -1.88018 -0.439682 -0.388162 -4.07322 -2.33918 9.17346 +6 2 -2.47021 -0.801057 -1.79014 -4.11028 -2.07522 1.70143 +7 1 -0.576352 1.99233 -0.135801 8.33914 8.33997 -1.40304 +8 2 -0.93279 1.50467 0.607511 -5.01196 -5.05095 3.69276 +9 2 -0.967697 1.61396 -0.924499 -2.96791 -3.60448 -2.11522 +10 1 0.996682 -1.16249 1.41603 -5.52393 -2.7768 9.00886 +11 2 0.982553 -1.62276 0.577115 -1.00274 -4.80219 -7.71302 +12 2 1.55168 -0.404501 1.24312 4.97383 8.09577 -0.603791 +13 1 0.964232 -1.37715 -1.32734 3.83388 -12.0598 -0.0980446 +14 2 0.0575072 -1.10802 -1.48098 -4.628 4.85469 -1.01689 +15 2 1.48931 -0.58697 -1.19891 1.1914 7.02562 -0.119366 +16 1 2.01083 1.04528 -0.114231 6.83173 -12.9986 1.26494 +17 2 1.17034 1.50303 -0.133551 -9.79274 8.34256 -0.476042 +18 2 2.7022 1.69874 -0.182183 2.76884 5.3999 -0.639748 +ITEM: TIMESTEP +80 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.51177 -0.182537 1.47592 -13.1365 10.3139 -11.8951 +2 2 -0.654143 -0.583091 1.57918 18.6975 -8.17701 1.44433 +3 2 -1.97348 -0.365352 2.2852 -6.58467 -1.56222 9.05296 +4 1 -1.74352 -0.377279 -1.33693 -0.505822 0.308788 -3.25308 +5 2 -1.91188 -0.438855 -0.39405 1.95743 0.358158 9.20234 +6 2 -2.48397 -0.807922 -1.76244 -1.16931 -0.70018 -3.86005 +7 1 -0.571778 1.99034 -0.138544 1.3921 0.315501 -1.43854 +8 2 -0.938419 1.50232 0.602337 -1.22478 -1.30903 4.8686 +9 2 -0.959599 1.56918 -0.90914 -0.0288155 0.574454 -3.52808 +10 1 0.985435 -1.15713 1.41811 -6.25848 -6.25702 9.27302 +11 2 0.972167 -1.59168 0.560031 1.69554 -0.201305 -5.06875 +12 2 1.54032 -0.386652 1.30283 4.96928 5.72762 -4.15176 +13 1 0.963614 -1.3793 -1.33436 0.183354 -1.1048 0.823621 +14 2 0.065336 -1.06423 -1.45856 -4.4409 -1.33366 -2.05511 +15 2 1.49256 -0.587857 -1.21654 4.36346 2.23441 0.338535 +16 1 2.00803 1.04345 -0.110717 3.61274 -3.25471 0.639326 +17 2 1.16919 1.51061 -0.133404 -8.46417 2.50048 0.10369 +18 2 2.67828 1.72068 -0.16597 4.94198 1.56662 -0.49597 +ITEM: TIMESTEP +90 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.50159 -0.186388 1.47232 -10.1666 8.56134 -9.06842 +2 2 -0.637201 -0.589948 1.58141 9.00709 -5.13609 3.43504 +3 2 -1.97805 -0.327506 2.28752 -1.76215 -2.05269 5.01359 +4 1 -1.7485 -0.377921 -1.33249 5.81313 3.27044 -5.4853 +5 2 -1.87141 -0.433051 -0.37781 -3.50795 -2.5324 4.09176 +6 2 -2.48522 -0.804273 -1.77362 -2.18894 -1.0456 2.79096 +7 1 -0.568425 1.98378 -0.140489 1.33268 1.60885 -0.760228 +8 2 -0.945484 1.51375 0.61188 -1.03442 -1.79649 -0.570033 +9 2 -0.936389 1.56212 -0.924193 -1.07342 -0.200973 1.02154 +10 1 0.975854 -1.15481 1.42351 1.86741 -2.52595 -4.21318 +11 2 0.98193 -1.53917 0.537259 -2.6087 -4.02599 1.03016 +12 2 1.52752 -0.379325 1.30866 2.98513 5.11632 2.51897 +13 1 0.962056 -1.37771 -1.33914 1.58342 -3.36145 0.893222 +14 2 0.0608833 -1.06855 -1.4877 0.530861 1.7595 -0.414339 +15 2 1.52774 -0.603203 -1.25083 -2.15602 1.98356 -0.537593 +16 1 2.00483 1.04652 -0.10624 2.44039 -5.05754 0.604689 +17 2 1.15126 1.49959 -0.126569 -0.261743 3.34267 -0.115684 +18 2 2.69252 1.71134 -0.15978 -0.800158 2.09248 -0.235157 +ITEM: TIMESTEP +100 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.49915 -0.184572 1.46491 -1.64286 -0.923423 4.11541 +2 2 -0.634606 -0.601439 1.61658 -0.503947 1.48506 -2.91046 +3 2 -1.9835 -0.312527 2.28463 -1.23961 0.673264 -1.96712 +4 1 -1.74898 -0.375873 -1.32741 -4.05983 -3.09974 1.92324 +5 2 -1.86884 -0.471305 -0.372769 3.24632 2.33491 1.76011 +6 2 -2.50916 -0.806172 -1.72327 1.14638 0.924599 -3.12385 +7 1 -0.564884 1.97778 -0.142101 -4.14881 -3.0738 -0.168062 +8 2 -0.958996 1.4911 0.595477 2.25574 1.20147 -1.85844 +9 2 -0.937749 1.56372 -0.930264 1.31445 2.00952 1.76263 +10 1 0.975211 -1.15256 1.42364 -0.947501 -4.6035 2.62584 +11 2 0.950951 -1.55837 0.541757 3.10583 4.89391 1.85772 +12 2 1.52342 -0.363228 1.34082 0.672959 -1.69053 -5.30235 +13 1 0.962361 -1.37851 -1.34242 -1.40487 6.54708 -1.50719 +14 2 0.0703818 -1.05861 -1.53269 1.44041 -3.14031 1.12109 +15 2 1.51335 -0.586474 -1.29057 -0.612624 -3.69916 1.63647 +16 1 2.00445 1.04687 -0.100669 -1.02523 8.04786 -0.336895 +17 2 1.16075 1.52969 -0.119062 2.24423 -4.67525 0.190963 +18 2 2.68635 1.72058 -0.160395 0.158945 -3.21195 0.180894 diff --git a/examples/amoeba/dump.water_hexamer.amoeba.4 b/examples/amoeba/dump.water_hexamer.amoeba.4 new file mode 100644 index 0000000000..88e888cc45 --- /dev/null +++ b/examples/amoeba/dump.water_hexamer.amoeba.4 @@ -0,0 +1,297 @@ +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.50217 -0.191359 1.43493 15.8836 -7.45837 3.84323 +2 2 -0.601054 -0.596972 1.55372 -22.9153 9.01978 -0.990133 +3 2 -2.0067 -0.422327 2.21985 1.01155 0.118537 -0.791932 +4 1 -1.74457 -0.382348 -1.30914 -6.66041 -3.92202 8.41554 +5 2 -1.88894 -0.479653 -0.347624 4.77968 3.15053 -8.64245 +6 2 -2.51683 -0.766765 -1.73377 2.90782 1.57916 -0.744558 +7 1 -0.560409 2.01783 -0.121984 -13.2194 -12.8195 1.43178 +8 2 -0.94772 1.53357 0.625228 6.08473 6.021 -1.58068 +9 2 -0.989831 1.59274 -0.877419 5.83415 5.52991 -0.337029 +10 1 0.964803 -1.16576 1.43999 12.6547 2.88136 -21.3636 +11 2 0.979557 -1.52204 0.527833 -3.6968 -1.92725 12.6575 +12 2 1.54222 -0.393692 1.34437 -3.37883 -2.73031 5.998 +13 1 0.974705 -1.4015 -1.33597 -6.12193 14.8514 -0.790538 +14 2 0.065161 -1.11895 -1.52289 4.56017 -6.05436 1.71545 +15 2 1.47071 -0.570933 -1.27771 1.31912 -7.40942 1.06098 +16 1 2.00228 1.05782 -0.124502 -10.3736 10.8414 -1.12005 +17 2 1.14164 1.53227 -0.140121 11.8812 -8.20067 0.772116 +18 2 2.67472 1.73534 -0.237995 -0.550493 -3.47117 0.466398 +ITEM: TIMESTEP +10 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.50661 -0.189383 1.4364 14.5938 -8.99605 8.72579 +2 2 -0.616993 -0.604745 1.5716 -17.7352 9.03346 -4.01613 +3 2 -2.01184 -0.421588 2.22126 -0.664878 1.39015 -2.52743 +4 1 -1.74564 -0.383429 -1.31051 0.451442 -0.432875 3.71075 +5 2 -1.85676 -0.451272 -0.342641 -1.17801 0.27861 -9.12816 +6 2 -2.51648 -0.764704 -1.74119 1.00433 0.523826 3.94489 +7 1 -0.565581 2.01415 -0.121947 -0.431671 0.816258 1.37224 +8 2 -0.923503 1.54613 0.649943 -0.836345 -0.35076 -8.91816 +9 2 -0.954982 1.61593 -0.9136 -0.398984 -1.29665 6.9827 +10 1 0.971315 -1.16462 1.43403 2.66632 -4.10463 -4.1745 +11 2 0.960388 -1.57587 0.54557 3.80791 8.56867 8.0783 +12 2 1.545 -0.38505 1.37422 -2.3984 -5.62816 -5.66197 +13 1 0.972827 -1.39712 -1.33549 -1.10638 0.442925 0.267527 +14 2 0.0526434 -1.14464 -1.51395 7.06933 2.8298 1.48943 +15 2 1.50554 -0.590868 -1.25662 -6.54392 -2.53639 -0.258333 +16 1 2.00275 1.0584 -0.124848 -7.13185 5.38221 -0.0306111 +17 2 1.13969 1.52381 -0.134074 11.7308 -4.5992 -0.113372 +18 2 2.68869 1.72277 -0.237084 -2.89819 -1.32119 0.257039 +ITEM: TIMESTEP +20 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.51649 -0.18584 1.44395 5.65501 -4.20149 4.07802 +2 2 -0.637196 -0.60535 1.5789 -10.2535 4.51311 -0.350867 +3 2 -2.05196 -0.408647 2.21473 3.52072 0.575858 -3.20585 +4 1 -1.74216 -0.383007 -1.31779 -5.65244 -1.7459 7.46957 +5 2 -1.85838 -0.422286 -0.35262 3.57624 0.698487 -5.03248 +6 2 -2.53778 -0.772973 -1.68856 2.62304 1.05785 -2.46299 +7 1 -0.568621 2.01502 -0.121788 -7.49291 -10.5083 -0.07078 +8 2 -0.953332 1.50031 0.601729 3.90339 5.1027 1.32659 +9 2 -0.948304 1.59097 -0.90055 3.2198 4.86429 -1.5712 +10 1 0.981527 -1.16776 1.43139 8.19382 2.30469 -14.0571 +11 2 0.999682 -1.57682 0.548153 -4.17545 -1.46604 7.90595 +12 2 1.55686 -0.401102 1.29785 -3.41945 -1.35828 5.31582 +13 1 0.971997 -1.39727 -1.33295 -3.50737 11.1512 0.685267 +14 2 0.0679408 -1.0929 -1.49373 1.59713 -5.72522 -0.144088 +15 2 1.47933 -0.582056 -1.22295 2.04209 -4.76253 -0.234646 +16 1 2.00557 1.05551 -0.12468 -4.4992 7.40197 -0.448564 +17 2 1.16008 1.5422 -0.129327 5.1837 -4.83397 0.46283 +18 2 2.69054 1.72007 -0.238059 -0.51465 -3.06849 0.334482 +ITEM: TIMESTEP +30 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.52872 -0.18011 1.45173 -0.933277 -2.21949 5.98424 +2 2 -0.665459 -0.602256 1.60472 0.633036 0.719099 -1.22127 +3 2 -2.07366 -0.404666 2.21589 2.60377 1.4581 -4.42661 +4 1 -1.74225 -0.382648 -1.3226 2.4731 1.57235 -0.799694 +5 2 -1.81423 -0.398932 -0.35676 -3.06045 -1.92828 -1.63228 +6 2 -2.5352 -0.77665 -1.69294 0.0233925 -0.139311 2.03217 +7 1 -0.576286 2.0073 -0.122823 5.68391 5.42307 0.543301 +8 2 -0.95235 1.50691 0.611905 -2.48677 -2.29116 -3.6455 +9 2 -0.915502 1.63076 -0.941481 -3.12923 -3.02599 2.90572 +10 1 0.998541 -1.16996 1.42191 -2.76709 -0.0175982 4.85417 +11 2 0.970261 -1.63876 0.575717 2.4618 4.28015 -0.493825 +12 2 1.54742 -0.386783 1.27666 -1.41861 -3.70889 -3.67396 +13 1 0.969317 -1.3895 -1.32829 2.03562 -5.48364 0.295138 +14 2 0.0583035 -1.11723 -1.49206 1.73159 3.49229 -0.0543931 +15 2 1.50655 -0.600283 -1.19205 -3.9925 1.94925 -1.04523 +16 1 2.00848 1.05446 -0.124132 1.88868 -1.58075 0.754117 +17 2 1.16959 1.53865 -0.11771 0.573913 1.34283 -0.58573 +18 2 2.71517 1.69464 -0.239075 -2.32089 0.157967 0.209615 +ITEM: TIMESTEP +40 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.53726 -0.175397 1.46121 -7.56641 2.45844 -0.518817 +2 2 -0.675238 -0.584022 1.60915 7.85196 -3.99237 1.67217 +3 2 -2.08862 -0.402087 2.21789 3.0617 0.39778 -2.04562 +4 1 -1.73949 -0.379604 -1.32819 -2.36016 -0.787528 -0.0315325 +5 2 -1.83346 -0.428429 -0.37056 1.90026 0.717301 4.17358 +6 2 -2.53017 -0.786871 -1.68316 0.151557 -0.108901 -3.75615 +7 1 -0.576955 2.0043 -0.124416 -0.431513 -1.54355 -1.46354 +8 2 -0.992092 1.48382 0.567817 1.09284 0.418387 6.78235 +9 2 -0.944746 1.62819 -0.925975 0.76441 1.37882 -5.22407 +10 1 1.00941 -1.17308 1.4189 -1.85973 4.64458 1.0889 +11 2 0.973659 -1.6403 0.580693 -1.69219 -4.78957 -3.29195 +12 2 1.53559 -0.396477 1.19908 0.544307 1.46508 3.63166 +13 1 0.969009 -1.38744 -1.3228 -0.275569 1.85307 -0.63583 +14 2 0.0737932 -1.09141 -1.50366 -4.66851 -2.83882 -1.16892 +15 2 1.46633 -0.576681 -1.19175 5.00795 0.70617 0.521536 +16 1 2.01183 1.05054 -0.121932 4.41526 -1.70685 -0.0836272 +17 2 1.19121 1.55327 -0.120038 -7.25224 2.19125 0.154184 +18 2 2.71636 1.68982 -0.237383 1.31607 -0.463304 0.195666 +ITEM: TIMESTEP +50 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.53986 -0.172749 1.46865 -10.3641 5.96951 -4.41562 +2 2 -0.678724 -0.568486 1.60775 14.9207 -7.13278 2.04782 +3 2 -2.07217 -0.405364 2.23045 -0.725799 -0.490948 1.77161 +4 1 -1.74113 -0.378171 -1.32957 5.99712 2.85952 -9.13842 +5 2 -1.82713 -0.447378 -0.375703 -3.89226 -1.3818 7.11516 +6 2 -2.4999 -0.790471 -1.74187 -3.02333 -1.60416 1.77146 +7 1 -0.579496 1.99691 -0.128028 9.72738 10.7655 -0.463519 +8 2 -0.97832 1.50522 0.591572 -4.4866 -5.64841 2.33138 +9 2 -0.951447 1.66071 -0.944057 -3.97244 -4.92262 -1.79974 +10 1 1.01358 -1.17192 1.41393 -6.48605 2.83151 13.495 +11 2 0.960671 -1.668 0.598799 0.887838 -3.18341 -9.75086 +12 2 1.53449 -0.394669 1.19537 2.46945 2.14925 -1.89795 +13 1 0.966791 -1.38037 -1.31946 4.73561 -12.449 -1.17286 +14 2 0.0653014 -1.12956 -1.52441 -4.76491 5.51904 -0.304595 +15 2 1.48076 -0.580834 -1.19775 0.0522693 6.36707 0.249418 +16 1 2.01309 1.04924 -0.119438 7.79557 -11.0594 0.778107 +17 2 1.18753 1.53519 -0.124654 -9.57007 7.63584 -0.456674 +18 2 2.72824 1.67508 -0.226016 0.699647 3.77524 -0.159727 +ITEM: TIMESTEP +60 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.535 -0.173529 1.47468 -12.8115 9.37187 -10.8344 +2 2 -0.673508 -0.564245 1.59147 19.3914 -9.12777 2.73797 +3 2 -2.04099 -0.404174 2.24807 -3.82175 -1.70255 6.71674 +4 1 -1.73996 -0.376347 -1.33351 0.570165 0.280665 -6.43548 +5 2 -1.87928 -0.466718 -0.390362 1.26398 0.876645 10.7815 +6 2 -2.48657 -0.801116 -1.75201 -2.14828 -1.00411 -3.66812 +7 1 -0.576718 1.99595 -0.131852 3.14419 3.30092 -1.47913 +8 2 -0.97416 1.49195 0.577492 -1.32391 -2.58987 8.72867 +9 2 -0.983297 1.63168 -0.91691 -0.334419 -0.770035 -7.07098 +10 1 1.00791 -1.1681 1.41401 -6.20027 1.07549 12.575 +11 2 0.972875 -1.65454 0.593802 -0.476084 -5.46772 -10.3478 +12 2 1.54632 -0.404877 1.20306 3.83119 5.88484 -0.834958 +13 1 0.966385 -1.38017 -1.32091 1.49436 -4.60495 -1.57148 +14 2 0.0722824 -1.10128 -1.51274 -8.16812 -0.531008 -1.13308 +15 2 1.45394 -0.565765 -1.20718 7.01226 4.42564 1.66198 +16 1 2.01308 1.04537 -0.116618 6.94232 -7.944 0.350248 +17 2 1.19126 1.53332 -0.135036 -13.3157 5.74475 0.221956 +18 2 2.70715 1.69348 -0.205764 4.95008 2.7812 -0.398561 +ITEM: TIMESTEP +70 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.52447 -0.177745 1.47754 -14.009 12.5988 -14.9127 +2 2 -0.663619 -0.56979 1.57126 20.9018 -10.2143 3.8986 +3 2 -2.00537 -0.388653 2.26816 -5.41735 -2.91391 10.0958 +4 1 -1.74327 -0.377755 -1.33511 7.69657 4.1782 -9.73798 +5 2 -1.88018 -0.439682 -0.388162 -4.07322 -2.33918 9.17346 +6 2 -2.47021 -0.801057 -1.79014 -4.11028 -2.07522 1.70143 +7 1 -0.576352 1.99233 -0.135801 8.33914 8.33997 -1.40304 +8 2 -0.93279 1.50467 0.607511 -5.01196 -5.05095 3.69276 +9 2 -0.967697 1.61396 -0.924499 -2.96791 -3.60448 -2.11522 +10 1 0.996682 -1.16249 1.41603 -5.52393 -2.7768 9.00886 +11 2 0.982553 -1.62276 0.577115 -1.00274 -4.80219 -7.71302 +12 2 1.55168 -0.404501 1.24312 4.97383 8.09577 -0.603791 +13 1 0.964232 -1.37715 -1.32734 3.83388 -12.0598 -0.0980446 +14 2 0.0575072 -1.10802 -1.48098 -4.628 4.85469 -1.01689 +15 2 1.48931 -0.58697 -1.19891 1.1914 7.02562 -0.119366 +16 1 2.01083 1.04528 -0.114231 6.83173 -12.9986 1.26494 +17 2 1.17034 1.50303 -0.133551 -9.79274 8.34256 -0.476042 +18 2 2.7022 1.69874 -0.182183 2.76884 5.3999 -0.639748 +ITEM: TIMESTEP +80 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.51177 -0.182537 1.47592 -13.1365 10.3139 -11.8951 +2 2 -0.654143 -0.583091 1.57918 18.6975 -8.17701 1.44433 +3 2 -1.97348 -0.365352 2.2852 -6.58467 -1.56222 9.05296 +4 1 -1.74352 -0.377279 -1.33693 -0.505822 0.308788 -3.25308 +5 2 -1.91188 -0.438855 -0.39405 1.95743 0.358158 9.20234 +6 2 -2.48397 -0.807922 -1.76244 -1.16931 -0.70018 -3.86005 +7 1 -0.571778 1.99034 -0.138544 1.3921 0.315501 -1.43854 +8 2 -0.938419 1.50232 0.602337 -1.22478 -1.30903 4.8686 +9 2 -0.959599 1.56918 -0.90914 -0.0288155 0.574454 -3.52808 +10 1 0.985435 -1.15713 1.41811 -6.25848 -6.25702 9.27302 +11 2 0.972167 -1.59168 0.560031 1.69554 -0.201305 -5.06875 +12 2 1.54032 -0.386652 1.30283 4.96928 5.72762 -4.15176 +13 1 0.963614 -1.3793 -1.33436 0.183354 -1.1048 0.823621 +14 2 0.065336 -1.06423 -1.45856 -4.4409 -1.33366 -2.05511 +15 2 1.49256 -0.587857 -1.21654 4.36346 2.23441 0.338535 +16 1 2.00803 1.04345 -0.110717 3.61274 -3.25471 0.639326 +17 2 1.16919 1.51061 -0.133404 -8.46417 2.50048 0.10369 +18 2 2.67828 1.72068 -0.16597 4.94198 1.56662 -0.49597 +ITEM: TIMESTEP +90 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.50159 -0.186388 1.47232 -10.1666 8.56134 -9.06842 +2 2 -0.637201 -0.589948 1.58141 9.00709 -5.13609 3.43504 +3 2 -1.97805 -0.327506 2.28752 -1.76215 -2.05269 5.01359 +4 1 -1.7485 -0.377921 -1.33249 5.81313 3.27044 -5.4853 +5 2 -1.87141 -0.433051 -0.37781 -3.50795 -2.5324 4.09176 +6 2 -2.48522 -0.804273 -1.77362 -2.18894 -1.0456 2.79096 +7 1 -0.568425 1.98378 -0.140489 1.33268 1.60885 -0.760228 +8 2 -0.945484 1.51375 0.61188 -1.03442 -1.79649 -0.570033 +9 2 -0.936389 1.56212 -0.924193 -1.07342 -0.200973 1.02154 +10 1 0.975854 -1.15481 1.42351 1.86741 -2.52595 -4.21318 +11 2 0.98193 -1.53917 0.537259 -2.6087 -4.02599 1.03016 +12 2 1.52752 -0.379325 1.30866 2.98513 5.11632 2.51897 +13 1 0.962056 -1.37771 -1.33914 1.58342 -3.36145 0.893222 +14 2 0.0608833 -1.06855 -1.4877 0.530861 1.7595 -0.414339 +15 2 1.52774 -0.603203 -1.25083 -2.15602 1.98356 -0.537593 +16 1 2.00483 1.04652 -0.10624 2.44039 -5.05754 0.604689 +17 2 1.15126 1.49959 -0.126569 -0.261743 3.34267 -0.115684 +18 2 2.69252 1.71134 -0.15978 -0.800158 2.09248 -0.235157 +ITEM: TIMESTEP +100 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.49915 -0.184572 1.46491 -1.64286 -0.923423 4.11541 +2 2 -0.634606 -0.601439 1.61658 -0.503947 1.48506 -2.91046 +3 2 -1.9835 -0.312527 2.28463 -1.23961 0.673264 -1.96712 +4 1 -1.74898 -0.375873 -1.32741 -4.05983 -3.09974 1.92324 +5 2 -1.86884 -0.471305 -0.372769 3.24632 2.33491 1.76011 +6 2 -2.50916 -0.806172 -1.72327 1.14638 0.924599 -3.12385 +7 1 -0.564884 1.97778 -0.142101 -4.14881 -3.0738 -0.168062 +8 2 -0.958996 1.4911 0.595477 2.25574 1.20147 -1.85844 +9 2 -0.937749 1.56372 -0.930264 1.31445 2.00952 1.76263 +10 1 0.975211 -1.15256 1.42364 -0.947501 -4.6035 2.62584 +11 2 0.950951 -1.55837 0.541757 3.10583 4.89391 1.85772 +12 2 1.52342 -0.363228 1.34082 0.672959 -1.69053 -5.30235 +13 1 0.962361 -1.37851 -1.34242 -1.40487 6.54708 -1.50719 +14 2 0.0703818 -1.05861 -1.53269 1.44041 -3.14031 1.12109 +15 2 1.51335 -0.586474 -1.29057 -0.612624 -3.69916 1.63647 +16 1 2.00445 1.04687 -0.100669 -1.02523 8.04786 -0.336895 +17 2 1.16075 1.52969 -0.119062 2.24423 -4.67525 0.190963 +18 2 2.68635 1.72058 -0.160395 0.158945 -3.21195 0.180894 diff --git a/examples/amoeba/dump.water_hexamer.hippo.1 b/examples/amoeba/dump.water_hexamer.hippo.1 new file mode 100644 index 0000000000..a808eb88d8 --- /dev/null +++ b/examples/amoeba/dump.water_hexamer.hippo.1 @@ -0,0 +1,297 @@ +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.50217 -0.191359 1.43493 19.9357 -10.2022 6.39617 +2 2 -0.601054 -0.596972 1.55372 -26.7746 11.7551 -3.2269 +3 2 -2.0067 -0.422327 2.21985 2.27453 0.843475 -3.26617 +4 1 -1.74457 -0.382348 -1.30914 -7.45906 -3.26138 10.4208 +5 2 -1.88894 -0.479653 -0.347624 4.39096 1.86538 -10.993 +6 2 -2.51683 -0.766765 -1.73377 3.97889 2.0308 0.238005 +7 1 -0.560409 2.01783 -0.121984 -15.0354 -12.151 1.41176 +8 2 -0.94772 1.53357 0.625228 7.62359 5.98784 -1.89388 +9 2 -0.989831 1.59274 -0.877419 6.55934 4.96076 0.527359 +10 1 0.964803 -1.16576 1.43999 15.4285 1.35636 -21.3173 +11 2 0.979557 -1.52204 0.527833 -6.23862 0.631634 14.3987 +12 2 1.54222 -0.393692 1.34437 -5.98579 -2.68738 6.2337 +13 1 0.974705 -1.4015 -1.33597 -5.70279 13.9492 -3.53962 +14 2 0.065161 -1.11895 -1.52289 5.16041 -6.4649 2.71211 +15 2 1.47071 -0.570933 -1.27771 0.726496 -6.9774 1.88925 +16 1 2.00228 1.05782 -0.124502 -11.1831 12.6873 -1.41281 +17 2 1.14164 1.53227 -0.140121 14.1175 -10.0366 0.774885 +18 2 2.67472 1.73534 -0.237995 -1.81661 -4.28693 0.646829 +ITEM: TIMESTEP +10 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.50519 -0.189085 1.43489 16.1346 -9.03082 7.39643 +2 2 -0.613325 -0.596599 1.55623 -19.7 9.16793 -3.06694 +3 2 -2.00781 -0.423676 2.21968 1.11569 1.33017 -3.51515 +4 1 -1.74545 -0.38218 -1.30921 -0.873137 -0.924011 5.81502 +5 2 -1.86379 -0.472478 -0.34573 -0.592473 0.521176 -9.80595 +6 2 -2.51308 -0.764814 -1.7423 1.95383 0.883641 3.34899 +7 1 -0.566746 2.01551 -0.121884 -0.752908 0.880358 1.51675 +8 2 -0.90288 1.53899 0.653422 -0.370038 -0.282546 -8.72932 +9 2 -0.948386 1.59852 -0.906373 -0.161598 -1.83495 7.27882 +10 1 0.972994 -1.16632 1.4367 2.1365 -3.63541 -4.30666 +11 2 0.921471 -1.54563 0.536978 3.92948 8.96444 9.02535 +12 2 1.51571 -0.366599 1.37318 -3.05971 -5.7155 -5.67471 +13 1 0.973913 -1.39785 -1.33834 -1.44621 0.344209 -0.720777 +14 2 0.0503221 -1.15099 -1.50181 7.085 2.52089 1.36272 +15 2 1.49605 -0.587274 -1.24124 -6.30793 -2.23617 0.0453877 +16 1 2.00301 1.05777 -0.1249 -8.37521 5.68727 -0.0787125 +17 2 1.13805 1.51682 -0.135757 12.8554 -4.94557 -0.27859 +18 2 2.68412 1.72611 -0.2366 -3.57128 -1.69512 0.387339 +ITEM: TIMESTEP +20 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.51053 -0.184679 1.43662 2.59225 -2.34383 2.4228 +2 2 -0.638864 -0.59446 1.56144 -3.81751 1.45077 0.169365 +3 2 -2.02892 -0.415768 2.21112 1.3915 0.960529 -2.2268 +4 1 -1.7422 -0.380161 -1.31156 -2.81538 -1.6524 5.61723 +5 2 -1.87085 -0.467579 -0.355121 2.06181 1.26201 -3.01668 +6 2 -2.51909 -0.769609 -1.71571 1.56589 0.868196 -2.04346 +7 1 -0.571857 2.01726 -0.121524 -4.42229 -10.7497 0.101549 +8 2 -0.894989 1.49275 0.621756 1.9428 5.13739 2.3456 +9 2 -0.928333 1.53949 -0.878364 1.74391 4.55343 -2.63937 +10 1 0.983665 -1.17004 1.43811 2.15858 5.32924 -12.0192 +11 2 0.916986 -1.51176 0.532863 -0.801958 -4.34579 6.00669 +12 2 1.48632 -0.356933 1.30471 -0.115562 -1.35756 5.38685 +13 1 0.974155 -1.39809 -1.34091 -3.6872 9.81415 2.33229 +14 2 0.0608639 -1.11508 -1.47548 0.727822 -4.45373 -1.43277 +15 2 1.45945 -0.57705 -1.18377 2.74992 -3.83937 -1.32423 +16 1 2.0041 1.05318 -0.12468 -4.82863 5.07797 -0.287867 +17 2 1.15863 1.52924 -0.140109 2.7798 -3.05413 0.358119 +18 2 2.67895 1.72504 -0.234758 0.77424 -2.65718 0.249897 +ITEM: TIMESTEP +30 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.5148 -0.180382 1.43888 -14.0787 7.25927 -2.0787 +2 2 -0.670243 -0.596746 1.58256 15.1847 -7.27642 2.26385 +3 2 -2.0578 -0.394757 2.19803 0.335566 -0.184039 0.277588 +4 1 -1.73953 -0.378972 -1.31065 5.17639 2.63373 -5.13987 +5 2 -1.85923 -0.443728 -0.358889 -2.57415 -1.51426 3.86387 +6 2 -2.50599 -0.762479 -1.73443 -2.25678 -0.997735 0.886673 +7 1 -0.57869 2.00716 -0.122116 7.46708 7.5609 -0.932554 +8 2 -0.891326 1.5227 0.646189 -3.77932 -4.24552 -0.379656 +9 2 -0.906489 1.54888 -0.899539 -3.74504 -3.89196 0.775918 +10 1 0.993915 -1.16716 1.4314 -4.03671 -0.827424 10.5116 +11 2 0.932938 -1.58361 0.567361 1.80347 1.36047 -5.88474 +12 2 1.49414 -0.355801 1.3027 1.34198 0.116597 -4.03649 +13 1 0.970608 -1.38983 -1.33905 4.21477 -7.05635 0.421831 +14 2 0.0575618 -1.13428 -1.49637 -1.45416 4.35852 0.0411765 +15 2 1.48422 -0.594211 -1.16216 -2.77696 3.0816 -1.11496 +16 1 2.00096 1.05017 -0.124007 4.94447 -7.97826 1.06585 +17 2 1.17138 1.53183 -0.140668 -5.63771 5.40691 -0.274313 +18 2 2.7082 1.68479 -0.23083 -0.128954 2.19398 -0.267092 +ITEM: TIMESTEP +40 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.5186 -0.17605 1.44225 -24.1552 14.2056 -8.76949 +2 2 -0.687962 -0.594151 1.59127 27.1026 -13.0552 4.45143 +3 2 -2.07116 -0.378379 2.19317 -1.29427 -1.5252 3.96365 +4 1 -1.73305 -0.375414 -1.31137 2.16372 2.0419 -7.75161 +5 2 -1.87951 -0.450834 -0.370226 0.624847 -0.775772 11.2387 +6 2 -2.50254 -0.754697 -1.72909 -2.50645 -1.07375 -3.54713 +7 1 -0.578876 1.99941 -0.124067 2.19183 2.88771 -2.2033 +8 2 -0.936478 1.52242 0.623048 -0.431918 -2.06784 8.93732 +9 2 -0.943689 1.52907 -0.872983 -0.503357 -0.655131 -7.36871 +10 1 1.00066 -1.16525 1.43041 -2.12968 1.37125 11.5778 +11 2 0.974279 -1.60078 0.583019 -3.02955 -6.45349 -11.2722 +12 2 1.51087 -0.375422 1.25067 2.49642 6.22795 1.24643 +13 1 0.96952 -1.38626 -1.33641 3.1199 -1.09706 -1.06644 +14 2 0.0736705 -1.0998 -1.50988 -8.20047 -1.85824 -0.95018 +15 2 1.45433 -0.57243 -1.18601 5.63783 2.37426 1.20997 +16 1 1.9962 1.04317 -0.122075 10.6231 -9.89832 0.540427 +17 2 1.19663 1.55837 -0.138658 -15.3708 7.22601 0.146924 +18 2 2.71508 1.6609 -0.228386 3.66149 2.12531 -0.383549 +ITEM: TIMESTEP +50 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.52326 -0.171807 1.44556 -19.3809 13.2253 -10.6114 +2 2 -0.679923 -0.574818 1.57581 25.4624 -12.0419 4.4477 +3 2 -2.05017 -0.382025 2.20867 -3.53537 -2.33472 6.62258 +4 1 -1.72947 -0.37135 -1.31158 7.45117 4.03521 -12.7525 +5 2 -1.85272 -0.46757 -0.370426 -4.08312 -1.86842 12.0545 +6 2 -2.4914 -0.737252 -1.75485 -4.03109 -2.01148 0.403261 +7 1 -0.581812 1.98886 -0.127591 8.73336 12.0451 -2.23223 +8 2 -0.927295 1.54015 0.641551 -4.26906 -6.45964 5.24049 +9 2 -0.953055 1.5416 -0.887204 -3.28906 -5.2042 -3.24355 +10 1 1.00866 -1.16393 1.43094 -5.76797 0.688141 16.3003 +11 2 0.941718 -1.59751 0.586621 -0.69625 -5.79697 -13.9615 +12 2 1.5005 -0.365594 1.24465 4.16474 6.46538 -1.29083 +13 1 0.968591 -1.37822 -1.33754 5.88173 -13.6635 -0.995409 +14 2 0.058765 -1.13465 -1.50083 -6.65826 5.43105 -0.991523 +15 2 1.47128 -0.574689 -1.20309 0.663977 7.53437 1.14922 +16 1 1.99172 1.03702 -0.120004 11.7209 -15.9347 1.25003 +17 2 1.18616 1.54124 -0.127765 -14.4197 10.6401 -0.950727 +18 2 2.7224 1.64022 -0.223578 2.05256 5.25094 -0.438473 +ITEM: TIMESTEP +60 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.52514 -0.169424 1.44931 -5.6044 5.71407 -7.65735 +2 2 -0.654856 -0.548823 1.55951 12.8877 -6.19997 1.70589 +3 2 -2.01089 -0.399975 2.23335 -4.71544 -1.47688 6.26364 +4 1 -1.72371 -0.366036 -1.3145 0.154709 0.0103655 -5.79078 +5 2 -1.86537 -0.486382 -0.375504 0.204748 0.738589 9.60402 +6 2 -2.49691 -0.728317 -1.74343 -1.12209 -0.453095 -3.27306 +7 1 -0.582396 1.98478 -0.131637 3.0799 3.10149 -1.36944 +8 2 -0.917703 1.51358 0.63199 -1.67497 -1.52591 5.69623 +9 2 -0.95935 1.51373 -0.876424 -0.704912 -1.0485 -4.50039 +10 1 1.01141 -1.16147 1.43332 -7.40944 0.284109 12.5023 +11 2 0.911102 -1.56686 0.573359 1.73368 -3.47737 -10.1102 +12 2 1.49548 -0.352196 1.26684 4.34342 4.22027 -2.29553 +13 1 0.969684 -1.37685 -1.34222 -0.51092 -4.11589 -0.224969 +14 2 0.0587056 -1.1173 -1.48363 -6.15339 -0.904158 -2.27293 +15 2 1.44029 -0.555019 -1.20354 6.44357 4.32801 1.75924 +16 1 1.98854 1.02727 -0.117121 5.38674 -4.81439 0.472007 +17 2 1.17286 1.52668 -0.137432 -10.3716 4.01885 -0.196355 +18 2 2.69 1.66639 -0.213741 4.03261 1.60042 -0.312306 +ITEM: TIMESTEP +70 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.52005 -0.170765 1.45435 7.42813 -0.682132 -3.31568 +2 2 -0.627795 -0.545781 1.54703 -4.484 0.351316 0.767932 +3 2 -1.9938 -0.405389 2.24937 -1.65789 -0.838399 2.61041 +4 1 -1.72181 -0.363627 -1.31513 2.63115 1.26887 -2.8752 +5 2 -1.86247 -0.45623 -0.365408 -2.65258 -1.1368 1.02525 +6 2 -2.4895 -0.712321 -1.77001 -0.898587 -0.369019 2.21573 +7 1 -0.583063 1.97962 -0.135858 1.67055 0.570004 -0.383383 +8 2 -0.908051 1.51128 0.64094 -1.16679 -0.0785678 -0.520586 +9 2 -0.943124 1.49995 -0.888932 -0.754685 -0.199723 0.596245 +10 1 1.00431 -1.15529 1.43647 -0.676345 0.911353 -2.95012 +11 2 0.95109 -1.53365 0.551095 -1.85378 -3.64627 0.0738184 +12 2 1.52689 -0.36229 1.29214 1.34973 2.90443 2.73267 +13 1 0.96764 -1.3732 -1.34735 0.830518 -7.82237 0.0710001 +14 2 0.049796 -1.13062 -1.50565 0.0671147 3.17314 0.120857 +15 2 1.46341 -0.566541 -1.18509 -0.178936 4.65822 -0.507667 +16 1 1.98438 1.02188 -0.114233 -0.881295 -2.57322 0.275288 +17 2 1.13419 1.48172 -0.149659 1.87909 1.86036 0.463365 +18 2 2.6735 1.67987 -0.202074 -0.651386 1.64881 -0.399918 +ITEM: TIMESTEP +80 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.50978 -0.173017 1.45833 15.0482 -9.57345 5.77126 +2 2 -0.617503 -0.581602 1.56045 -17.3455 8.85736 -2.90765 +3 2 -1.99215 -0.403845 2.25671 0.833211 1.42908 -3.53001 +4 1 -1.71857 -0.360372 -1.31644 -7.32338 -2.11362 6.45601 +5 2 -1.89982 -0.440583 -0.365391 4.39327 0.727605 -4.87947 +6 2 -2.49827 -0.701359 -1.75982 2.51785 1.20426 -1.18541 +7 1 -0.581108 1.97455 -0.140769 -3.87733 -3.80002 1.10694 +8 2 -0.928789 1.51932 0.641149 2.19408 2.20718 -5.07369 +9 2 -0.943839 1.48954 -0.89443 1.32563 2.05291 3.72773 +10 1 0.995847 -1.14613 1.43537 0.755936 -5.6909 -0.46639 +11 2 0.966841 -1.55186 0.550806 1.56938 7.42451 5.54707 +12 2 1.55511 -0.362342 1.35836 -2.79165 -2.9995 -5.36768 +13 1 0.967816 -1.37465 -1.35163 -3.29308 4.65803 -0.872226 +14 2 0.0602027 -1.09254 -1.5264 2.56737 -3.64929 1.27094 +15 2 1.45854 -0.559392 -1.19328 1.84002 -1.84978 0.0538636 +16 1 1.98052 1.0158 -0.111184 -7.14388 11.5516 -0.816233 +17 2 1.12003 1.47724 -0.140032 8.70268 -6.85942 1.26876 +18 2 2.64114 1.706 -0.201685 0.0272078 -3.57662 -0.103793 +ITEM: TIMESTEP +90 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.50003 -0.175917 1.46165 15.3898 -11.884 8.8546 +2 2 -0.608584 -0.600731 1.57129 -23.7815 11.9323 -1.75151 +3 2 -2.00991 -0.394435 2.25305 5.57059 1.55514 -7.64598 +4 1 -1.72137 -0.357368 -1.31563 -1.93902 -0.246344 7.85181 +5 2 -1.87234 -0.43987 -0.353482 -0.118832 -0.772284 -11.4834 +6 2 -2.49861 -0.682857 -1.77755 1.48512 0.513779 4.12935 +7 1 -0.579472 1.97061 -0.145894 -8.85759 -8.26094 2.77276 +8 2 -0.945449 1.52054 0.635243 4.66427 4.57627 -6.94972 +9 2 -0.952686 1.48464 -0.897126 3.60343 4.09955 4.74753 +10 1 0.988258 -1.14419 1.44127 11.1074 1.88534 -20.9154 +11 2 0.971991 -1.50516 0.531218 -4.29535 0.162687 14.3489 +12 2 1.5415 -0.356231 1.32305 -5.76468 -4.25266 5.91571 +13 1 0.969416 -1.37359 -1.35605 -1.23717 3.53556 0.174563 +14 2 0.053578 -1.1004 -1.52114 7.10928 -0.236326 1.96556 +15 2 1.49219 -0.569722 -1.21186 -5.0738 -3.24139 -1.5161 +16 1 1.97824 1.01566 -0.108279 -8.95647 8.69277 0.191958 +17 2 1.10027 1.45664 -0.104435 15.9218 -5.21388 -1.22481 +18 2 2.64464 1.70165 -0.21558 -4.82724 -2.84557 0.534172 +ITEM: TIMESTEP +100 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.4951 -0.17739 1.46185 11.6291 -12.0775 13.5087 +2 2 -0.608426 -0.588808 1.60852 -19.0988 9.4339 -4.86631 +3 2 -2.01619 -0.397996 2.24676 4.77562 3.06476 -9.1756 +4 1 -1.72287 -0.352149 -1.31567 -8.10325 -4.84048 12.8242 +5 2 -1.86729 -0.479262 -0.356777 4.49726 3.58866 -11.0242 +6 2 -2.51926 -0.676876 -1.74282 3.42966 1.20159 -1.20299 +7 1 -0.581355 1.96754 -0.149521 -5.24612 -4.66563 2.71982 +8 2 -0.935394 1.51644 0.636953 2.89489 2.96603 -9.31226 +9 2 -0.942573 1.488 -0.91114 1.96254 2.34604 7.29302 +10 1 0.988651 -1.14425 1.44045 0.840008 -1.36718 -7.83612 +11 2 0.899639 -1.53136 0.543246 5.64911 9.69241 11.7913 +12 2 1.49178 -0.318235 1.33897 -3.7582 -9.86315 -4.79205 +13 1 0.974233 -1.37573 -1.35945 -3.77942 11.331 0.435153 +14 2 0.0583408 -1.08758 -1.49668 6.15796 -3.89994 -0.197074 +15 2 1.48764 -0.558876 -1.24121 -3.14566 -8.24544 0.525665 +16 1 1.97883 1.01496 -0.10404 -9.03485 15.6667 -0.929518 +17 2 1.11471 1.47883 -0.106249 11.9101 -8.77208 -0.858699 +18 2 2.63671 1.70526 -0.232286 -1.57994 -5.55972 1.09694 diff --git a/examples/amoeba/dump.water_hexamer.hippo.4 b/examples/amoeba/dump.water_hexamer.hippo.4 new file mode 100644 index 0000000000..a808eb88d8 --- /dev/null +++ b/examples/amoeba/dump.water_hexamer.hippo.4 @@ -0,0 +1,297 @@ +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.50217 -0.191359 1.43493 19.9357 -10.2022 6.39617 +2 2 -0.601054 -0.596972 1.55372 -26.7746 11.7551 -3.2269 +3 2 -2.0067 -0.422327 2.21985 2.27453 0.843475 -3.26617 +4 1 -1.74457 -0.382348 -1.30914 -7.45906 -3.26138 10.4208 +5 2 -1.88894 -0.479653 -0.347624 4.39096 1.86538 -10.993 +6 2 -2.51683 -0.766765 -1.73377 3.97889 2.0308 0.238005 +7 1 -0.560409 2.01783 -0.121984 -15.0354 -12.151 1.41176 +8 2 -0.94772 1.53357 0.625228 7.62359 5.98784 -1.89388 +9 2 -0.989831 1.59274 -0.877419 6.55934 4.96076 0.527359 +10 1 0.964803 -1.16576 1.43999 15.4285 1.35636 -21.3173 +11 2 0.979557 -1.52204 0.527833 -6.23862 0.631634 14.3987 +12 2 1.54222 -0.393692 1.34437 -5.98579 -2.68738 6.2337 +13 1 0.974705 -1.4015 -1.33597 -5.70279 13.9492 -3.53962 +14 2 0.065161 -1.11895 -1.52289 5.16041 -6.4649 2.71211 +15 2 1.47071 -0.570933 -1.27771 0.726496 -6.9774 1.88925 +16 1 2.00228 1.05782 -0.124502 -11.1831 12.6873 -1.41281 +17 2 1.14164 1.53227 -0.140121 14.1175 -10.0366 0.774885 +18 2 2.67472 1.73534 -0.237995 -1.81661 -4.28693 0.646829 +ITEM: TIMESTEP +10 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.50519 -0.189085 1.43489 16.1346 -9.03082 7.39643 +2 2 -0.613325 -0.596599 1.55623 -19.7 9.16793 -3.06694 +3 2 -2.00781 -0.423676 2.21968 1.11569 1.33017 -3.51515 +4 1 -1.74545 -0.38218 -1.30921 -0.873137 -0.924011 5.81502 +5 2 -1.86379 -0.472478 -0.34573 -0.592473 0.521176 -9.80595 +6 2 -2.51308 -0.764814 -1.7423 1.95383 0.883641 3.34899 +7 1 -0.566746 2.01551 -0.121884 -0.752908 0.880358 1.51675 +8 2 -0.90288 1.53899 0.653422 -0.370038 -0.282546 -8.72932 +9 2 -0.948386 1.59852 -0.906373 -0.161598 -1.83495 7.27882 +10 1 0.972994 -1.16632 1.4367 2.1365 -3.63541 -4.30666 +11 2 0.921471 -1.54563 0.536978 3.92948 8.96444 9.02535 +12 2 1.51571 -0.366599 1.37318 -3.05971 -5.7155 -5.67471 +13 1 0.973913 -1.39785 -1.33834 -1.44621 0.344209 -0.720777 +14 2 0.0503221 -1.15099 -1.50181 7.085 2.52089 1.36272 +15 2 1.49605 -0.587274 -1.24124 -6.30793 -2.23617 0.0453877 +16 1 2.00301 1.05777 -0.1249 -8.37521 5.68727 -0.0787125 +17 2 1.13805 1.51682 -0.135757 12.8554 -4.94557 -0.27859 +18 2 2.68412 1.72611 -0.2366 -3.57128 -1.69512 0.387339 +ITEM: TIMESTEP +20 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.51053 -0.184679 1.43662 2.59225 -2.34383 2.4228 +2 2 -0.638864 -0.59446 1.56144 -3.81751 1.45077 0.169365 +3 2 -2.02892 -0.415768 2.21112 1.3915 0.960529 -2.2268 +4 1 -1.7422 -0.380161 -1.31156 -2.81538 -1.6524 5.61723 +5 2 -1.87085 -0.467579 -0.355121 2.06181 1.26201 -3.01668 +6 2 -2.51909 -0.769609 -1.71571 1.56589 0.868196 -2.04346 +7 1 -0.571857 2.01726 -0.121524 -4.42229 -10.7497 0.101549 +8 2 -0.894989 1.49275 0.621756 1.9428 5.13739 2.3456 +9 2 -0.928333 1.53949 -0.878364 1.74391 4.55343 -2.63937 +10 1 0.983665 -1.17004 1.43811 2.15858 5.32924 -12.0192 +11 2 0.916986 -1.51176 0.532863 -0.801958 -4.34579 6.00669 +12 2 1.48632 -0.356933 1.30471 -0.115562 -1.35756 5.38685 +13 1 0.974155 -1.39809 -1.34091 -3.6872 9.81415 2.33229 +14 2 0.0608639 -1.11508 -1.47548 0.727822 -4.45373 -1.43277 +15 2 1.45945 -0.57705 -1.18377 2.74992 -3.83937 -1.32423 +16 1 2.0041 1.05318 -0.12468 -4.82863 5.07797 -0.287867 +17 2 1.15863 1.52924 -0.140109 2.7798 -3.05413 0.358119 +18 2 2.67895 1.72504 -0.234758 0.77424 -2.65718 0.249897 +ITEM: TIMESTEP +30 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.5148 -0.180382 1.43888 -14.0787 7.25927 -2.0787 +2 2 -0.670243 -0.596746 1.58256 15.1847 -7.27642 2.26385 +3 2 -2.0578 -0.394757 2.19803 0.335566 -0.184039 0.277588 +4 1 -1.73953 -0.378972 -1.31065 5.17639 2.63373 -5.13987 +5 2 -1.85923 -0.443728 -0.358889 -2.57415 -1.51426 3.86387 +6 2 -2.50599 -0.762479 -1.73443 -2.25678 -0.997735 0.886673 +7 1 -0.57869 2.00716 -0.122116 7.46708 7.5609 -0.932554 +8 2 -0.891326 1.5227 0.646189 -3.77932 -4.24552 -0.379656 +9 2 -0.906489 1.54888 -0.899539 -3.74504 -3.89196 0.775918 +10 1 0.993915 -1.16716 1.4314 -4.03671 -0.827424 10.5116 +11 2 0.932938 -1.58361 0.567361 1.80347 1.36047 -5.88474 +12 2 1.49414 -0.355801 1.3027 1.34198 0.116597 -4.03649 +13 1 0.970608 -1.38983 -1.33905 4.21477 -7.05635 0.421831 +14 2 0.0575618 -1.13428 -1.49637 -1.45416 4.35852 0.0411765 +15 2 1.48422 -0.594211 -1.16216 -2.77696 3.0816 -1.11496 +16 1 2.00096 1.05017 -0.124007 4.94447 -7.97826 1.06585 +17 2 1.17138 1.53183 -0.140668 -5.63771 5.40691 -0.274313 +18 2 2.7082 1.68479 -0.23083 -0.128954 2.19398 -0.267092 +ITEM: TIMESTEP +40 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.5186 -0.17605 1.44225 -24.1552 14.2056 -8.76949 +2 2 -0.687962 -0.594151 1.59127 27.1026 -13.0552 4.45143 +3 2 -2.07116 -0.378379 2.19317 -1.29427 -1.5252 3.96365 +4 1 -1.73305 -0.375414 -1.31137 2.16372 2.0419 -7.75161 +5 2 -1.87951 -0.450834 -0.370226 0.624847 -0.775772 11.2387 +6 2 -2.50254 -0.754697 -1.72909 -2.50645 -1.07375 -3.54713 +7 1 -0.578876 1.99941 -0.124067 2.19183 2.88771 -2.2033 +8 2 -0.936478 1.52242 0.623048 -0.431918 -2.06784 8.93732 +9 2 -0.943689 1.52907 -0.872983 -0.503357 -0.655131 -7.36871 +10 1 1.00066 -1.16525 1.43041 -2.12968 1.37125 11.5778 +11 2 0.974279 -1.60078 0.583019 -3.02955 -6.45349 -11.2722 +12 2 1.51087 -0.375422 1.25067 2.49642 6.22795 1.24643 +13 1 0.96952 -1.38626 -1.33641 3.1199 -1.09706 -1.06644 +14 2 0.0736705 -1.0998 -1.50988 -8.20047 -1.85824 -0.95018 +15 2 1.45433 -0.57243 -1.18601 5.63783 2.37426 1.20997 +16 1 1.9962 1.04317 -0.122075 10.6231 -9.89832 0.540427 +17 2 1.19663 1.55837 -0.138658 -15.3708 7.22601 0.146924 +18 2 2.71508 1.6609 -0.228386 3.66149 2.12531 -0.383549 +ITEM: TIMESTEP +50 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.52326 -0.171807 1.44556 -19.3809 13.2253 -10.6114 +2 2 -0.679923 -0.574818 1.57581 25.4624 -12.0419 4.4477 +3 2 -2.05017 -0.382025 2.20867 -3.53537 -2.33472 6.62258 +4 1 -1.72947 -0.37135 -1.31158 7.45117 4.03521 -12.7525 +5 2 -1.85272 -0.46757 -0.370426 -4.08312 -1.86842 12.0545 +6 2 -2.4914 -0.737252 -1.75485 -4.03109 -2.01148 0.403261 +7 1 -0.581812 1.98886 -0.127591 8.73336 12.0451 -2.23223 +8 2 -0.927295 1.54015 0.641551 -4.26906 -6.45964 5.24049 +9 2 -0.953055 1.5416 -0.887204 -3.28906 -5.2042 -3.24355 +10 1 1.00866 -1.16393 1.43094 -5.76797 0.688141 16.3003 +11 2 0.941718 -1.59751 0.586621 -0.69625 -5.79697 -13.9615 +12 2 1.5005 -0.365594 1.24465 4.16474 6.46538 -1.29083 +13 1 0.968591 -1.37822 -1.33754 5.88173 -13.6635 -0.995409 +14 2 0.058765 -1.13465 -1.50083 -6.65826 5.43105 -0.991523 +15 2 1.47128 -0.574689 -1.20309 0.663977 7.53437 1.14922 +16 1 1.99172 1.03702 -0.120004 11.7209 -15.9347 1.25003 +17 2 1.18616 1.54124 -0.127765 -14.4197 10.6401 -0.950727 +18 2 2.7224 1.64022 -0.223578 2.05256 5.25094 -0.438473 +ITEM: TIMESTEP +60 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.52514 -0.169424 1.44931 -5.6044 5.71407 -7.65735 +2 2 -0.654856 -0.548823 1.55951 12.8877 -6.19997 1.70589 +3 2 -2.01089 -0.399975 2.23335 -4.71544 -1.47688 6.26364 +4 1 -1.72371 -0.366036 -1.3145 0.154709 0.0103655 -5.79078 +5 2 -1.86537 -0.486382 -0.375504 0.204748 0.738589 9.60402 +6 2 -2.49691 -0.728317 -1.74343 -1.12209 -0.453095 -3.27306 +7 1 -0.582396 1.98478 -0.131637 3.0799 3.10149 -1.36944 +8 2 -0.917703 1.51358 0.63199 -1.67497 -1.52591 5.69623 +9 2 -0.95935 1.51373 -0.876424 -0.704912 -1.0485 -4.50039 +10 1 1.01141 -1.16147 1.43332 -7.40944 0.284109 12.5023 +11 2 0.911102 -1.56686 0.573359 1.73368 -3.47737 -10.1102 +12 2 1.49548 -0.352196 1.26684 4.34342 4.22027 -2.29553 +13 1 0.969684 -1.37685 -1.34222 -0.51092 -4.11589 -0.224969 +14 2 0.0587056 -1.1173 -1.48363 -6.15339 -0.904158 -2.27293 +15 2 1.44029 -0.555019 -1.20354 6.44357 4.32801 1.75924 +16 1 1.98854 1.02727 -0.117121 5.38674 -4.81439 0.472007 +17 2 1.17286 1.52668 -0.137432 -10.3716 4.01885 -0.196355 +18 2 2.69 1.66639 -0.213741 4.03261 1.60042 -0.312306 +ITEM: TIMESTEP +70 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.52005 -0.170765 1.45435 7.42813 -0.682132 -3.31568 +2 2 -0.627795 -0.545781 1.54703 -4.484 0.351316 0.767932 +3 2 -1.9938 -0.405389 2.24937 -1.65789 -0.838399 2.61041 +4 1 -1.72181 -0.363627 -1.31513 2.63115 1.26887 -2.8752 +5 2 -1.86247 -0.45623 -0.365408 -2.65258 -1.1368 1.02525 +6 2 -2.4895 -0.712321 -1.77001 -0.898587 -0.369019 2.21573 +7 1 -0.583063 1.97962 -0.135858 1.67055 0.570004 -0.383383 +8 2 -0.908051 1.51128 0.64094 -1.16679 -0.0785678 -0.520586 +9 2 -0.943124 1.49995 -0.888932 -0.754685 -0.199723 0.596245 +10 1 1.00431 -1.15529 1.43647 -0.676345 0.911353 -2.95012 +11 2 0.95109 -1.53365 0.551095 -1.85378 -3.64627 0.0738184 +12 2 1.52689 -0.36229 1.29214 1.34973 2.90443 2.73267 +13 1 0.96764 -1.3732 -1.34735 0.830518 -7.82237 0.0710001 +14 2 0.049796 -1.13062 -1.50565 0.0671147 3.17314 0.120857 +15 2 1.46341 -0.566541 -1.18509 -0.178936 4.65822 -0.507667 +16 1 1.98438 1.02188 -0.114233 -0.881295 -2.57322 0.275288 +17 2 1.13419 1.48172 -0.149659 1.87909 1.86036 0.463365 +18 2 2.6735 1.67987 -0.202074 -0.651386 1.64881 -0.399918 +ITEM: TIMESTEP +80 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.50978 -0.173017 1.45833 15.0482 -9.57345 5.77126 +2 2 -0.617503 -0.581602 1.56045 -17.3455 8.85736 -2.90765 +3 2 -1.99215 -0.403845 2.25671 0.833211 1.42908 -3.53001 +4 1 -1.71857 -0.360372 -1.31644 -7.32338 -2.11362 6.45601 +5 2 -1.89982 -0.440583 -0.365391 4.39327 0.727605 -4.87947 +6 2 -2.49827 -0.701359 -1.75982 2.51785 1.20426 -1.18541 +7 1 -0.581108 1.97455 -0.140769 -3.87733 -3.80002 1.10694 +8 2 -0.928789 1.51932 0.641149 2.19408 2.20718 -5.07369 +9 2 -0.943839 1.48954 -0.89443 1.32563 2.05291 3.72773 +10 1 0.995847 -1.14613 1.43537 0.755936 -5.6909 -0.46639 +11 2 0.966841 -1.55186 0.550806 1.56938 7.42451 5.54707 +12 2 1.55511 -0.362342 1.35836 -2.79165 -2.9995 -5.36768 +13 1 0.967816 -1.37465 -1.35163 -3.29308 4.65803 -0.872226 +14 2 0.0602027 -1.09254 -1.5264 2.56737 -3.64929 1.27094 +15 2 1.45854 -0.559392 -1.19328 1.84002 -1.84978 0.0538636 +16 1 1.98052 1.0158 -0.111184 -7.14388 11.5516 -0.816233 +17 2 1.12003 1.47724 -0.140032 8.70268 -6.85942 1.26876 +18 2 2.64114 1.706 -0.201685 0.0272078 -3.57662 -0.103793 +ITEM: TIMESTEP +90 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.50003 -0.175917 1.46165 15.3898 -11.884 8.8546 +2 2 -0.608584 -0.600731 1.57129 -23.7815 11.9323 -1.75151 +3 2 -2.00991 -0.394435 2.25305 5.57059 1.55514 -7.64598 +4 1 -1.72137 -0.357368 -1.31563 -1.93902 -0.246344 7.85181 +5 2 -1.87234 -0.43987 -0.353482 -0.118832 -0.772284 -11.4834 +6 2 -2.49861 -0.682857 -1.77755 1.48512 0.513779 4.12935 +7 1 -0.579472 1.97061 -0.145894 -8.85759 -8.26094 2.77276 +8 2 -0.945449 1.52054 0.635243 4.66427 4.57627 -6.94972 +9 2 -0.952686 1.48464 -0.897126 3.60343 4.09955 4.74753 +10 1 0.988258 -1.14419 1.44127 11.1074 1.88534 -20.9154 +11 2 0.971991 -1.50516 0.531218 -4.29535 0.162687 14.3489 +12 2 1.5415 -0.356231 1.32305 -5.76468 -4.25266 5.91571 +13 1 0.969416 -1.37359 -1.35605 -1.23717 3.53556 0.174563 +14 2 0.053578 -1.1004 -1.52114 7.10928 -0.236326 1.96556 +15 2 1.49219 -0.569722 -1.21186 -5.0738 -3.24139 -1.5161 +16 1 1.97824 1.01566 -0.108279 -8.95647 8.69277 0.191958 +17 2 1.10027 1.45664 -0.104435 15.9218 -5.21388 -1.22481 +18 2 2.64464 1.70165 -0.21558 -4.82724 -2.84557 0.534172 +ITEM: TIMESTEP +100 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.4951 -0.17739 1.46185 11.6291 -12.0775 13.5087 +2 2 -0.608426 -0.588808 1.60852 -19.0988 9.4339 -4.86631 +3 2 -2.01619 -0.397996 2.24676 4.77562 3.06476 -9.1756 +4 1 -1.72287 -0.352149 -1.31567 -8.10325 -4.84048 12.8242 +5 2 -1.86729 -0.479262 -0.356777 4.49726 3.58866 -11.0242 +6 2 -2.51926 -0.676876 -1.74282 3.42966 1.20159 -1.20299 +7 1 -0.581355 1.96754 -0.149521 -5.24612 -4.66563 2.71982 +8 2 -0.935394 1.51644 0.636953 2.89489 2.96603 -9.31226 +9 2 -0.942573 1.488 -0.91114 1.96254 2.34604 7.29302 +10 1 0.988651 -1.14425 1.44045 0.840008 -1.36718 -7.83612 +11 2 0.899639 -1.53136 0.543246 5.64911 9.69241 11.7913 +12 2 1.49178 -0.318235 1.33897 -3.7582 -9.86315 -4.79205 +13 1 0.974233 -1.37573 -1.35945 -3.77942 11.331 0.435153 +14 2 0.0583408 -1.08758 -1.49668 6.15796 -3.89994 -0.197074 +15 2 1.48764 -0.558876 -1.24121 -3.14566 -8.24544 0.525665 +16 1 1.97883 1.01496 -0.10404 -9.03485 15.6667 -0.929518 +17 2 1.11471 1.47883 -0.106249 11.9101 -8.77208 -0.858699 +18 2 2.63671 1.70526 -0.232286 -1.57994 -5.55972 1.09694 diff --git a/examples/amoeba/in.ubiquitin b/examples/amoeba/in.ubiquitin index 09df9aa5df..0af52b565a 100644 --- a/examples/amoeba/in.ubiquitin +++ b/examples/amoeba/in.ubiquitin @@ -36,19 +36,21 @@ special_bonds lj/coul 0.5 0.5 0.5 one/five yes # thermo output -compute virial all pressure NULL virial +compute virial all pressure NULL virial thermo_style custom step temp epair ebond eangle edihed eimp & emol etotal press c_virial[*] +dump 1 all custom 10 dump.ubi id type x y z fx fy fz +dump_modify 1 sort id + # zero step run -dump 1 all custom 10 dump.ubi id type x y z fx fy fz -run 0 +#run 0 # dynamics -#fix 1 all nve +fix 1 all nve -#thermo 10 -#run 100 +thermo 1 +run 10 diff --git a/examples/amoeba/in.water_box.amoeba b/examples/amoeba/in.water_box.amoeba index 1e1a72463e..1ee4fc0018 100644 --- a/examples/amoeba/in.water_box.amoeba +++ b/examples/amoeba/in.water_box.amoeba @@ -33,12 +33,16 @@ compute virial all pressure NULL virial thermo_style custom step temp epair ebond eangle edihed eimp & emol etotal press c_virial[*] +dump 1 all custom 10 dump.water_box id type x y z fx fy fz +dump_modify 1 sort id + # zero step run #run 0 # dynamics -thermo 1 fix 1 all nve + +thermo 10 run 100 diff --git a/examples/amoeba/in.water_box.hippo b/examples/amoeba/in.water_box.hippo index 49acb58317..2c414017f6 100644 --- a/examples/amoeba/in.water_box.hippo +++ b/examples/amoeba/in.water_box.hippo @@ -33,12 +33,16 @@ compute virial all pressure NULL virial thermo_style custom step temp epair ebond eangle edihed eimp & emol etotal press c_virial[*] +dump 1 all custom 10 dump.water_box id type x y z fx fy fz +dump_modify 1 sort id + # zero step run #run 0 # dynamics -thermo 1 fix 1 all nve + +thermo 10 run 100 diff --git a/examples/amoeba/in.water_dimer.amoeba b/examples/amoeba/in.water_dimer.amoeba index 9e9cae8ac3..66fa60e351 100644 --- a/examples/amoeba/in.water_dimer.amoeba +++ b/examples/amoeba/in.water_dimer.amoeba @@ -33,12 +33,16 @@ compute virial all pressure NULL virial thermo_style custom step temp epair ebond eangle edihed eimp & emol etotal press c_virial[*] +dump 1 all custom 10 dump.water_dimer id type x y z fx fy fz +dump_modify 1 sort id + # zero step run #run 0 # dynamics -thermo 1 fix 1 all nve + +thermo 10 run 100 diff --git a/examples/amoeba/in.water_dimer.hippo b/examples/amoeba/in.water_dimer.hippo index 1e9755570a..5ed920ffda 100644 --- a/examples/amoeba/in.water_dimer.hippo +++ b/examples/amoeba/in.water_dimer.hippo @@ -33,12 +33,16 @@ compute virial all pressure NULL virial thermo_style custom step temp epair ebond eangle edihed eimp & emol etotal press c_virial[*] +dump 1 all custom 10 dump.water_dimer id type x y z fx fy fz +dump_modify 1 sort id + # zero step run #run 0 # dynamics -thermo 1 fix 1 all nve + +thermo 10 run 100 diff --git a/examples/amoeba/in.water_hexamer.amoeba b/examples/amoeba/in.water_hexamer.amoeba index 0ce596a06c..bc14833778 100644 --- a/examples/amoeba/in.water_hexamer.amoeba +++ b/examples/amoeba/in.water_hexamer.amoeba @@ -33,12 +33,16 @@ compute virial all pressure NULL virial thermo_style custom step temp epair ebond eangle edihed eimp & emol etotal press c_virial[*] +dump 1 all custom 10 dump.water_hexamer id type x y z fx fy fz +dump_modify 1 sort id + # zero step run -run 0 +#run 0 # dynamics -#thermo 1 -#fix 1 all nve -#run 100 +fix 1 all nve + +thermo 10 +run 100 diff --git a/examples/amoeba/in.water_hexamer.hippo b/examples/amoeba/in.water_hexamer.hippo index 52f6e863a2..28a06dcefe 100644 --- a/examples/amoeba/in.water_hexamer.hippo +++ b/examples/amoeba/in.water_hexamer.hippo @@ -33,12 +33,16 @@ compute virial all pressure NULL virial thermo_style custom step temp epair ebond eangle edihed eimp & emol etotal press c_virial[*] +dump 1 all custom 10 dump.water_hexamer id type x y z fx fy fz +dump_modify 1 sort id + # zero step run -run 0 +#run 0 # dynamics -#thermo 1 -#fix 1 all nve -#run 100 +fix 1 all nve + +thermo 10 +run 100 diff --git a/examples/amoeba/log.ubi.1 b/examples/amoeba/log.ubi.1 new file mode 100644 index 0000000000..968a292fb5 --- /dev/null +++ b/examples/amoeba/log.ubi.1 @@ -0,0 +1,162 @@ +LAMMPS (24 Mar 2022) +# solvated ubiquitin molecule with AMOEBA force field + +units real +boundary p p p +atom_modify sort 0 0.0 + +atom_style amoeba + +bond_style class2 +angle_style amoeba +dihedral_style fourier +improper_style amoeba + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix pit all amoeba/pitorsion +fix_modify pit energy yes +fix bit all amoeba/bitorsion bitorsion.ubiquitin.data +fix_modify bit energy yes + +fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes +fix extra2 all property/atom i_polaxe + +#read_data data.ubiquitin fix amtype NULL "Tinker Types" +read_data data.ubiquitin fix amtype NULL "Tinker Types" fix pit "pitorsion types" "PiTorsion Coeffs" fix pit pitorsions PiTorsions fix bit bitorsions BiTorsions +Reading data file ... + orthogonal box = (0 0 0) to (54.99 41.91 41.91) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 9737 atoms + scanning bonds ... + 4 = max bonds/atom + scanning angles ... + 6 = max angles/atom + scanning dihedrals ... + 18 = max dihedrals/atom + scanning impropers ... + 3 = max impropers/atom + reading bonds ... + 6908 bonds + reading angles ... + 5094 angles + reading dihedrals ... + 3297 dihedrals + reading impropers ... + 651 impropers +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 4 = max # of 1-2 neighbors + 9 = max # of 1-3 neighbors + 19 = max # of 1-4 neighbors + 21 = max # of special neighbors + special bonds CPU = 0.004 seconds + read_data CPU = 0.075 seconds + +pair_style amoeba +pair_coeff * * amoeba_ubiquitin.prm amoeba_ubiquitin.key + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0.5 0.5 0.5 + special bond factors coul: 0.5 0.5 0.5 + 4 = max # of 1-2 neighbors + 9 = max # of 1-3 neighbors + 19 = max # of 1-4 neighbors + 58 = max # of 1-5 neighbors + 21 = max # of special neighbors + special bonds CPU = 0.006 seconds + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] + +dump 1 all custom 10 dump.ubi id type x y z fx fy fz +dump_modify 1 sort id + +# zero step run + +#run 0 + +# dynamics + +fix 1 all nve + +thermo 1 +run 10 +AMOEBA/HIPPO force field settings + hal: cut 12 taper 10.8 vscale 0 0 1 1 + multipole: cut 7 aewald 0.4 bsorder 5 FFT 60 48 48 mscale 0 0 0.4 1 + polar: cut 7 aewald 0.5 bsorder 5 FFT 60 48 48 + pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 1 1 1 1 d/u scale 0 1 + precondition: cut 4.5 + generated 0 of 15 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 14 + ghost atom cutoff = 14 + binsize = 7, bins = 8 6 6 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair amoeba, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d + bin: standard + AMOEBA/HIPPO group count: 3196 +Per MPI rank memory allocation (min/avg/max) = 98.55 | 98.55 | 98.55 Mbytes + Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] + 0 0 -35338.057 2856.5938 1955.5431 224.37609 65.00809 5101.5211 -30247.585 -6336.5196 -5795.4272 -6329.8149 -6884.3167 349.52657 77.164877 652.41925 + 1 29.61379 -35356.153 2037.3541 1840.7883 223.90217 64.293945 4166.3385 -30341.522 -6486.773 -6452.8463 -6841.5982 -7386.1106 311.38025 120.72605 545.35513 + 2 78.518242 -35383.65 825.39919 1538.3909 222.55095 62.191009 2648.5321 -30467.814 -5502.9841 -6410.2998 -6396.1829 -6937.8137 217.3515 210.76948 294.28051 + 3 88.8921 -35402.11 938.99299 1162.2914 220.5271 58.832521 2380.644 -30453.516 -1929.5417 -3331.1291 -2769.7218 -3350.5733 117.32302 279.72705 31.237776 + 4 68.740402 -35477.589 2048.0659 858.03795 218.14277 54.460022 3178.7066 -30316.325 2041.1138 594.25938 1665.7799 1030.8539 66.230421 304.28296 -155.80224 + 5 76.267862 -35707.869 2206.6534 736.37385 215.75693 49.401674 3208.1859 -30299.377 2276.9276 536.21124 1893.4621 1258.492 92.097191 299.65604 -228.58369 + 6 118.24373 -36092.77 1166.179 815.59206 213.67399 44.022297 2239.4673 -30435.629 -1677.8051 -3988.2428 -2669.6848 -3247.7207 197.42472 285.87129 -162.35459 + 7 137.7204 -36521.444 782.87113 1026.745 212.04289 38.686259 2060.3452 -30479.082 -5987.83 -8386.8104 -7363.188 -7888.261 357.00835 253.66346 32.827786 + 8 112.66452 -36897.181 1750.0569 1269.152 210.83571 33.742799 3263.7874 -30379.432 -7886.4081 -9703.2601 -9043.015 -9555.2908 490.76046 182.31259 278.727 + 9 88.237359 -37209.906 2695.1766 1454.55 209.91331 29.503458 4389.1434 -30276.565 -8202.16 -9492.368 -9110.7037 -9639.2288 502.55699 107.82333 443.6705 + +AMEOBA/HIPPO timing info: + Init time: 0.0257147 0.00113515 + Hal time: 7.6011 33.5542 + Mpole time: 2.25841 9.96952 + Induce time: 8.18934 36.151 + Polar time: 4.5786 20.2117 + Total time: 22.6532 + + 10 108.86756 -37474.988 2240.4603 1523.7936 209.10313 26.208515 3999.5656 -30333.279 -8468.4347 -9956.923 -9709.5874 -10224.682 365.98214 95.262991 425.12746 +Loop time of 22.6992 on 1 procs for 10 steps with 9737 atoms + +Performance: 0.038 ns/day, 630.534 hours/ns, 0.441 timesteps/s +98.8% CPU use with 1 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 22.653 | 22.653 | 22.653 | 0.0 | 99.80 +Bond | 0.014323 | 0.014323 | 0.014323 | 0.0 | 0.06 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.0035064 | 0.0035064 | 0.0035064 | 0.0 | 0.02 +Output | 0.024558 | 0.024558 | 0.024558 | 0.0 | 0.11 +Modify | 0.002901 | 0.002901 | 0.002901 | 0.0 | 0.01 +Other | | 0.0006384 | | | 0.00 + +Nlocal: 9737 ave 9737 max 9737 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 31511 ave 31511 max 31511 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 5.6393e+06 ave 5.6393e+06 max 5.6393e+06 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 5639296 +Ave neighs/atom = 579.16155 +Ave special neighs/atom = 3.1364897 +Neighbor list builds = 0 +Dangerous builds = 0 +Total wall time: 0:00:25 diff --git a/examples/amoeba/log.ubi.32 b/examples/amoeba/log.ubi.32 new file mode 100644 index 0000000000..6a21c3cb16 --- /dev/null +++ b/examples/amoeba/log.ubi.32 @@ -0,0 +1,162 @@ +LAMMPS (24 Mar 2022) +# solvated ubiquitin molecule with AMOEBA force field + +units real +boundary p p p +atom_modify sort 0 0.0 + +atom_style amoeba + +bond_style class2 +angle_style amoeba +dihedral_style fourier +improper_style amoeba + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix pit all amoeba/pitorsion +fix_modify pit energy yes +fix bit all amoeba/bitorsion bitorsion.ubiquitin.data +fix_modify bit energy yes + +fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes +fix extra2 all property/atom i_polaxe + +#read_data data.ubiquitin fix amtype NULL "Tinker Types" +read_data data.ubiquitin fix amtype NULL "Tinker Types" fix pit "pitorsion types" "PiTorsion Coeffs" fix pit pitorsions PiTorsions fix bit bitorsions BiTorsions +Reading data file ... + orthogonal box = (0 0 0) to (54.99 41.91 41.91) + 4 by 2 by 4 MPI processor grid + reading atoms ... + 9737 atoms + scanning bonds ... + 4 = max bonds/atom + scanning angles ... + 6 = max angles/atom + scanning dihedrals ... + 18 = max dihedrals/atom + scanning impropers ... + 3 = max impropers/atom + reading bonds ... + 6908 bonds + reading angles ... + 5094 angles + reading dihedrals ... + 3297 dihedrals + reading impropers ... + 651 impropers +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 4 = max # of 1-2 neighbors + 9 = max # of 1-3 neighbors + 19 = max # of 1-4 neighbors + 21 = max # of special neighbors + special bonds CPU = 0.002 seconds + read_data CPU = 0.125 seconds + +pair_style amoeba +pair_coeff * * amoeba_ubiquitin.prm amoeba_ubiquitin.key + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0.5 0.5 0.5 + special bond factors coul: 0.5 0.5 0.5 + 4 = max # of 1-2 neighbors + 9 = max # of 1-3 neighbors + 19 = max # of 1-4 neighbors + 58 = max # of 1-5 neighbors + 21 = max # of special neighbors + special bonds CPU = 0.002 seconds + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] + +dump 1 all custom 10 dump.ubi id type x y z fx fy fz +dump_modify 1 sort id + +# zero step run + +#run 0 + +# dynamics + +fix 1 all nve + +thermo 1 +run 10 +AMOEBA/HIPPO force field settings + hal: cut 12 taper 10.8 vscale 0 0 1 1 + multipole: cut 7 aewald 0.4 bsorder 5 FFT 60 48 48 mscale 0 0 0.4 1 + polar: cut 7 aewald 0.5 bsorder 5 FFT 60 48 48 + pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 1 1 1 1 d/u scale 0 1 + precondition: cut 4.5 + generated 0 of 15 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 14 + ghost atom cutoff = 14 + binsize = 7, bins = 8 6 6 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair amoeba, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d + bin: standard + AMOEBA/HIPPO group count: 3196 +Per MPI rank memory allocation (min/avg/max) = 26.19 | 26.49 | 27.59 Mbytes + Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] + 0 0 -35338.057 2856.5938 1955.5431 224.37609 65.00809 5101.5211 -30247.585 -6336.5196 -5795.4272 -6329.8149 -6884.3167 349.52657 77.164877 652.41925 + 1 29.61379 -35356.153 2037.3541 1840.7883 223.90217 64.293945 4166.3385 -30341.522 -6486.773 -6452.8463 -6841.5982 -7386.1106 311.38025 120.72605 545.35513 + 2 78.518242 -35383.65 825.39919 1538.3909 222.55095 62.191009 2648.5321 -30467.814 -5502.9841 -6410.2998 -6396.1829 -6937.8137 217.3515 210.76948 294.28051 + 3 88.8921 -35402.11 938.99299 1162.2914 220.5271 58.832521 2380.644 -30453.516 -1929.5417 -3331.1291 -2769.7218 -3350.5733 117.32302 279.72705 31.237776 + 4 68.740402 -35477.589 2048.0659 858.03795 218.14277 54.460022 3178.7066 -30316.325 2041.1138 594.25938 1665.7799 1030.8539 66.230421 304.28296 -155.80224 + 5 76.267862 -35707.869 2206.6534 736.37385 215.75693 49.401674 3208.1859 -30299.377 2276.9276 536.21124 1893.4621 1258.492 92.097191 299.65604 -228.58369 + 6 118.24373 -36092.77 1166.179 815.59206 213.67399 44.022297 2239.4673 -30435.629 -1677.8051 -3988.2428 -2669.6848 -3247.7207 197.42472 285.87129 -162.35459 + 7 137.7204 -36521.444 782.87113 1026.745 212.04289 38.686259 2060.3452 -30479.082 -5987.83 -8386.8104 -7363.188 -7888.261 357.00835 253.66346 32.827786 + 8 112.66452 -36897.181 1750.0569 1269.152 210.83571 33.742799 3263.7874 -30379.432 -7886.4081 -9703.2601 -9043.015 -9555.2908 490.76046 182.31259 278.727 + 9 88.237359 -37209.906 2695.1766 1454.55 209.91331 29.503458 4389.1434 -30276.565 -8202.16 -9492.368 -9110.7037 -9639.2288 502.55699 107.82333 443.6705 + +AMEOBA/HIPPO timing info: + Init time: 0.0350369 0.0194083 + Hal time: 0.274414 15.2009 + Mpole time: 0.209885 11.6263 + Induce time: 1.00414 55.6234 + Polar time: 0.281769 15.6083 + Total time: 1.80525 + + 10 108.86756 -37474.988 2240.4603 1523.7936 209.10313 26.208515 3999.5656 -30333.279 -8468.4347 -9956.923 -9709.5874 -10224.682 365.98214 95.262991 425.12746 +Loop time of 1.82311 on 32 procs for 10 steps with 9737 atoms + +Performance: 0.474 ns/day, 50.642 hours/ns, 5.485 timesteps/s +99.1% CPU use with 32 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 1.805 | 1.8057 | 1.8065 | 0.0 | 99.05 +Bond | 0.00027 | 0.00076775 | 0.0023491 | 0.0 | 0.04 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.0098412 | 0.011853 | 0.013048 | 0.8 | 0.65 +Output | 0.0038478 | 0.0041268 | 0.0045236 | 0.2 | 0.23 +Modify | 0.00019451 | 0.00034384 | 0.00063207 | 0.0 | 0.02 +Other | | 0.0003186 | | | 0.02 + +Nlocal: 304.281 ave 326 max 273 min +Histogram: 1 1 0 5 2 8 3 6 4 2 +Nghost: 7618.59 ave 7678 max 7545 min +Histogram: 1 1 4 4 5 5 2 2 4 4 +Neighs: 176228 ave 204476 max 149390 min +Histogram: 3 3 3 2 6 2 5 4 2 2 + +Total # of neighbors = 5639296 +Ave neighs/atom = 579.16155 +Ave special neighs/atom = 3.1364897 +Neighbor list builds = 0 +Dangerous builds = 0 +Total wall time: 0:00:02 diff --git a/examples/amoeba/log.water_box.amoeba.1 b/examples/amoeba/log.water_box.amoeba.1 new file mode 100644 index 0000000000..f8f887d800 --- /dev/null +++ b/examples/amoeba/log.water_box.amoeba.1 @@ -0,0 +1,149 @@ +LAMMPS (24 Mar 2022) +# water box with AMOEBA or HIPPO + +units real +boundary p p p + +atom_style amoeba +bond_style class2 +angle_style amoeba +dihedral_style none + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes +fix extra2 all property/atom i_polaxe + +# read data file + +read_data data.water_box.amoeba fix amtype NULL "Tinker Types" +Reading data file ... + orthogonal box = (0 0 0) to (18.643 18.643 18.643) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 648 atoms + scanning bonds ... + 2 = max bonds/atom + scanning angles ... + 1 = max angles/atom + reading bonds ... + 432 bonds + reading angles ... + 216 angles +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + read_data CPU = 0.011 seconds + +# force field + +pair_style amoeba +pair_coeff * * amoeba_water.prm amoeba_water_box.key + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0.5 0.5 0.5 + special bond factors coul: 0.5 0.5 0.5 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of 1-5 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.001 seconds + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] + +dump 1 all custom 10 dump.water_box id type x y z fx fy fz +dump_modify 1 sort id + +# zero step run + +#run 0 + +# dynamics + +fix 1 all nve + +thermo 10 +run 100 +AMOEBA/HIPPO force field settings + hal: cut 7 taper 6 vscale 0 0 1 1 + multipole: cut 7 aewald 0.4 bsorder 5 FFT 50 50 50 mscale 0 0 0.4 1 + polar: cut 7 aewald 0.5 bsorder 5 FFT 50 50 50 + pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 1 1 1 1 d/u scale 0 1 + precondition: cut 4.5 + generated 0 of 1 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 9 + ghost atom cutoff = 9 + binsize = 4.5, bins = 5 5 5 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair amoeba, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d + bin: standard + AMOEBA/HIPPO group count: 216 +Per MPI rank memory allocation (min/avg/max) = 10.9 | 10.9 | 10.9 Mbytes + Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] + 0 0 -2172.0441 166.82637 83.732524 0 0 250.5589 -1921.4852 -6181.7112 -4771.8292 -6955.3278 -6817.9765 -272.19746 3173.3487 2229.6526 + 10 105.50439 -2373.6865 136.67908 106.86552 0 0 243.54459 -1926.6678 -8441.2174 -10450.318 -9514.124 -9665.625 -301.45304 322.2435 1916.9694 + 20 143.90097 -2358.3516 70.951764 76.777106 0 0 147.72887 -1933.0976 -7370.463 -7728.4884 -11580.562 -8676.0017 -807.21546 780.4123 2096.7667 + 30 157.22768 -2375.4639 50.396281 87.108719 0 0 137.505 -1934.7321 -4449.9504 -6946.5881 -7865.3435 -4955.5443 -417.85139 -1004.0926 -36.630383 + 40 150.92709 -2354.1768 78.484257 53.799494 0 0 132.28375 -1930.8175 353.40845 -939.7978 -4636.1858 475.75837 -1074.4762 -1584.304 -574.27211 + 50 153.02614 -2388.7287 100.20124 65.814409 0 0 166.01565 -1927.5893 3975.1595 1366.008 426.2343 3887.1078 -1807.1658 -2534.8393 -2118.6912 + 60 155.01798 -2364.31 92.948309 44.252938 0 0 137.20125 -1928.1435 5793.7978 3521.2541 1421.9416 6110.7678 -1536.937 -2559.5674 -1502.2038 + 70 166.70629 -2383.4827 76.492455 55.020922 0 0 131.51338 -1930.4622 4743.9587 1916.6786 2839.9241 2670.7568 -169.67855 -187.58379 -2256.4529 + 80 171.82933 -2388.0347 76.463333 49.138785 0 0 125.60212 -1931.0453 2210.1222 -319.99043 330.98785 -394.25628 -44.858027 252.35533 -1985.0908 + 90 175.7327 -2423.7974 90.784969 63.725029 0 0 154.51 -1930.3722 -917.58179 -3941.9566 -2568.4278 -3415.3121 196.38051 2366.2885 -263.52434 + +AMEOBA/HIPPO timing info: + Init time: 0.0251099 0.000637177 + Hal time: 0.924614 2.34626 + Mpole time: 2.51306 6.37702 + Induce time: 29.8839 75.8319 + Polar time: 6.06136 15.381 + Total time: 39.408 + + 100 173.73319 -2422.3616 99.761403 57.29505 0 0 157.05645 -1930.2461 -3586.4169 -5733.9943 -5881.4025 -6235.1905 -230.75166 959.02899 406.2349 +Loop time of 39.4372 on 1 procs for 100 steps with 648 atoms + +Performance: 0.219 ns/day, 109.548 hours/ns, 2.536 timesteps/s +99.6% CPU use with 1 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 39.408 | 39.408 | 39.408 | 0.0 | 99.93 +Bond | 0.0033709 | 0.0033709 | 0.0033709 | 0.0 | 0.01 +Neigh | 0.0054251 | 0.0054251 | 0.0054251 | 0.0 | 0.01 +Comm | 0.0035919 | 0.0035919 | 0.0035919 | 0.0 | 0.01 +Output | 0.014523 | 0.014523 | 0.014523 | 0.0 | 0.04 +Modify | 0.00095298 | 0.00095298 | 0.00095298 | 0.0 | 0.00 +Other | | 0.001005 | | | 0.00 + +Nlocal: 648 ave 648 max 648 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 4290 ave 4290 max 4290 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 98543 ave 98543 max 98543 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 98543 +Ave neighs/atom = 152.07253 +Ave special neighs/atom = 2 +Neighbor list builds = 2 +Dangerous builds = 0 +Total wall time: 0:00:40 diff --git a/examples/amoeba/log.water_box.amoeba.32 b/examples/amoeba/log.water_box.amoeba.32 new file mode 100644 index 0000000000..859e13e229 --- /dev/null +++ b/examples/amoeba/log.water_box.amoeba.32 @@ -0,0 +1,149 @@ +LAMMPS (24 Mar 2022) +# water box with AMOEBA or HIPPO + +units real +boundary p p p + +atom_style amoeba +bond_style class2 +angle_style amoeba +dihedral_style none + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes +fix extra2 all property/atom i_polaxe + +# read data file + +read_data data.water_box.amoeba fix amtype NULL "Tinker Types" +Reading data file ... + orthogonal box = (0 0 0) to (18.643 18.643 18.643) + 2 by 4 by 4 MPI processor grid + reading atoms ... + 648 atoms + scanning bonds ... + 2 = max bonds/atom + scanning angles ... + 1 = max angles/atom + reading bonds ... + 432 bonds + reading angles ... + 216 angles +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.002 seconds + read_data CPU = 0.027 seconds + +# force field + +pair_style amoeba +pair_coeff * * amoeba_water.prm amoeba_water_box.key + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0.5 0.5 0.5 + special bond factors coul: 0.5 0.5 0.5 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of 1-5 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.002 seconds + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] + +dump 1 all custom 10 dump.water_box id type x y z fx fy fz +dump_modify 1 sort id + +# zero step run + +#run 0 + +# dynamics + +fix 1 all nve + +thermo 10 +run 100 +AMOEBA/HIPPO force field settings + hal: cut 7 taper 6 vscale 0 0 1 1 + multipole: cut 7 aewald 0.4 bsorder 5 FFT 50 50 50 mscale 0 0 0.4 1 + polar: cut 7 aewald 0.5 bsorder 5 FFT 50 50 50 + pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 1 1 1 1 d/u scale 0 1 + precondition: cut 4.5 + generated 0 of 1 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 9 + ghost atom cutoff = 9 + binsize = 4.5, bins = 5 5 5 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair amoeba, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d + bin: standard + AMOEBA/HIPPO group count: 216 +Per MPI rank memory allocation (min/avg/max) = 10.07 | 10.08 | 10.34 Mbytes + Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] + 0 0 -2172.0441 166.82637 83.732524 0 0 250.5589 -1921.4852 -6181.7112 -4771.8292 -6955.3278 -6817.9765 -272.19746 3173.3487 2229.6526 + 10 105.50439 -2373.6865 136.67908 106.86552 0 0 243.54459 -1926.6678 -8441.2174 -10450.318 -9514.124 -9665.625 -301.45304 322.2435 1916.9694 + 20 143.90097 -2358.3516 70.951764 76.777106 0 0 147.72887 -1933.0976 -7370.463 -7728.4884 -11580.562 -8676.0017 -807.21546 780.4123 2096.7667 + 30 157.22768 -2375.4639 50.396281 87.108719 0 0 137.505 -1934.7321 -4449.9504 -6946.5881 -7865.3435 -4955.5443 -417.85139 -1004.0926 -36.630383 + 40 150.92709 -2354.1768 78.484257 53.799494 0 0 132.28375 -1930.8175 353.40845 -939.7978 -4636.1858 475.75837 -1074.4762 -1584.304 -574.27211 + 50 153.02614 -2388.7287 100.20124 65.814409 0 0 166.01565 -1927.5893 3975.1595 1366.008 426.2343 3887.1078 -1807.1658 -2534.8393 -2118.6912 + 60 155.01798 -2364.31 92.948309 44.252938 0 0 137.20125 -1928.1435 5793.7978 3521.2541 1421.9416 6110.7678 -1536.937 -2559.5674 -1502.2038 + 70 166.70629 -2383.4827 76.492455 55.020922 0 0 131.51338 -1930.4622 4743.9587 1916.6786 2839.9241 2670.7568 -169.67855 -187.58379 -2256.4529 + 80 171.82933 -2388.0347 76.463333 49.138785 0 0 125.60212 -1931.0453 2210.1222 -319.99043 330.98785 -394.25628 -44.858027 252.35533 -1985.0908 + 90 175.7327 -2423.7974 90.784969 63.725029 0 0 154.51 -1930.3722 -917.58179 -3941.9566 -2568.4278 -3415.3121 196.38051 2366.2885 -263.52434 + +AMEOBA/HIPPO timing info: + Init time: 0.0525488 0.00776173 + Hal time: 0.037136 0.548518 + Mpole time: 0.586998 8.67026 + Induce time: 5.01628 74.093 + Polar time: 1.07725 15.9116 + Total time: 6.77025 + + 100 173.73319 -2422.3616 99.761403 57.29505 0 0 157.05645 -1930.2461 -3586.4169 -5733.9943 -5881.4025 -6235.1905 -230.75166 959.02899 406.2349 +Loop time of 6.80378 on 32 procs for 100 steps with 648 atoms + +Performance: 1.270 ns/day, 18.899 hours/ns, 14.698 timesteps/s +99.7% CPU use with 32 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 6.7643 | 6.7717 | 6.779 | 0.2 | 99.53 +Bond | 0.00031311 | 0.00044449 | 0.00060974 | 0.0 | 0.01 +Neigh | 0.00039627 | 0.00047385 | 0.00058355 | 0.0 | 0.01 +Comm | 0.018079 | 0.025388 | 0.03285 | 2.6 | 0.37 +Output | 0.0036767 | 0.0037103 | 0.0039596 | 0.1 | 0.05 +Modify | 0.00040095 | 0.00049993 | 0.00061333 | 0.0 | 0.01 +Other | | 0.001545 | | | 0.02 + +Nlocal: 20.25 ave 26 max 12 min +Histogram: 1 1 3 1 2 7 3 11 1 2 +Nghost: 1381.97 ave 1413 max 1354 min +Histogram: 3 5 4 0 6 3 1 4 5 1 +Neighs: 3079.47 ave 4080 max 1858 min +Histogram: 1 3 1 2 5 6 7 5 0 2 + +Total # of neighbors = 98543 +Ave neighs/atom = 152.07253 +Ave special neighs/atom = 2 +Neighbor list builds = 2 +Dangerous builds = 0 +Total wall time: 0:00:06 diff --git a/examples/amoeba/log.water_box.hippo.1 b/examples/amoeba/log.water_box.hippo.1 new file mode 100644 index 0000000000..a49db65721 --- /dev/null +++ b/examples/amoeba/log.water_box.hippo.1 @@ -0,0 +1,153 @@ +LAMMPS (24 Mar 2022) +# water box with AMOEBA or HIPPO + +units real +boundary p p p + +atom_style amoeba +bond_style class2 +angle_style amoeba +dihedral_style none + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes +fix extra2 all property/atom i_polaxe + +# read data file + +read_data data.water_box.hippo fix amtype NULL "Tinker Types" +Reading data file ... + orthogonal box = (0 0 0) to (18.643 18.643 18.643) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 648 atoms + scanning bonds ... + 2 = max bonds/atom + scanning angles ... + 1 = max angles/atom + reading bonds ... + 432 bonds + reading angles ... + 216 angles +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + read_data CPU = 0.010 seconds + +# force field + +pair_style hippo +pair_coeff * * hippo_water.prm hippo_water_box.key + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0.5 0.5 0.5 + special bond factors coul: 0.5 0.5 0.5 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of 1-5 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.001 seconds + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] + +dump 1 all custom 10 dump.water_box id type x y z fx fy fz +dump_modify 1 sort id + +# zero step run + +#run 0 + +# dynamics + +fix 1 all nve + +thermo 10 +run 100 +AMOEBA/HIPPO force field settings + repulsion: cut 7 taper 6 rscale 0 0 1 1 + qxfer: cut 7 taper 6 mscale 0 0 0.4 1 + dispersion: cut 7 aewald 0.45 bsorder 4 FFT 16 16 16 dspscale 0 0 0.4 1 + multipole: cut 7 aewald 0.4 bsorder 5 FFT 24 24 24 mscale 0 0 0.4 1 + polar: cut 7 aewald 0.5 bsorder 5 FFT 24 24 24 + pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 0.2 1 1 1 d/u scale 0 1 + precondition: cut 4.5 + generated 0 of 1 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 9 + ghost atom cutoff = 9 + binsize = 4.5, bins = 5 5 5 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair hippo, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d + bin: standard + AMOEBA/HIPPO group count: 216 +Per MPI rank memory allocation (min/avg/max) = 10.89 | 10.89 | 10.89 Mbytes + Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] + 0 0 -2188.594 166.82637 77.478353 0 0 244.30473 -1944.2893 -10859.589 -9285.4645 -11598.049 -11695.254 -282.7072 3164.4148 2495.2578 + 10 100.94691 -2350.192 116.13156 88.56605 0 0 204.69761 -1950.8098 -11480.919 -13574.139 -12190.797 -12798.212 -263.77028 280.62864 1974.1486 + 20 153.91622 -2358.3058 36.396961 66.22466 0 0 102.62162 -1958.8438 -7778.4529 -8492.3868 -11999.431 -9125.9998 -917.99962 589.09064 1788.2094 + 30 145.5951 -2343.9956 39.651541 65.833248 0 0 105.48479 -1957.7184 -288.79965 -2574.4466 -3820.4824 -414.28285 -347.51491 -1147.3995 -126.71025 + 40 126.87801 -2340.2623 102.93951 43.896946 0 0 146.83646 -1948.7309 6766.15 5908.7048 1280.0961 7930.8191 -1085.6811 -1596.6859 -714.82888 + 50 134.52078 -2358.9232 107.49288 44.253826 0 0 151.74671 -1947.7419 8762.4348 6023.4661 5377.0189 9396.0316 -1629.1364 -1663.1666 -2381.51 + 60 173.10181 -2374.3854 51.097314 33.03646 0 0 84.133774 -1956.4102 4614.2907 1719.1989 505.79149 4552.3167 -1661.1714 -587.92108 -1380.6732 + 70 184.86849 -2391.6106 39.916931 35.978152 0 0 75.895083 -1959.1811 -2146.9339 -4993.4021 -4095.6729 -4897.5768 -833.09046 1542.411 -1539.5266 + 80 164.75795 -2406.3017 101.94229 33.067832 0 0 135.01013 -1953.542 -8779.3265 -10545.409 -10418.702 -12098.858 -1319.194 1750.3511 -275.1272 + 90 151.17491 -2434.6876 152.21826 41.301673 0 0 193.51993 -1949.6141 -13330.691 -15436.505 -13791.461 -16934.674 149.25497 2289.1026 976.14333 + +AMEOBA/HIPPO timing info: + Init time: 0.0130348 0.00133126 + Repls time: 1.10221 11.257 + Disp time: 0.909199 9.28573 + Mpole time: 1.75286 17.9021 + Induce time: 3.46637 35.4024 + Polar time: 2.22081 22.6813 + Qxfer time: 0.326863 3.33828 + Total time: 9.79136 + + 100 166.99163 -2452.5298 143.57768 35.341459 0 0 178.91914 -1951.5533 -14918.51 -16077.49 -17353.738 -18140.466 19.009088 1487.0469 1084.0231 +Loop time of 9.81706 on 1 procs for 100 steps with 648 atoms + +Performance: 0.880 ns/day, 27.270 hours/ns, 10.186 timesteps/s +98.8% CPU use with 1 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 9.7915 | 9.7915 | 9.7915 | 0.0 | 99.74 +Bond | 0.0024566 | 0.0024566 | 0.0024566 | 0.0 | 0.03 +Neigh | 0.0056616 | 0.0056616 | 0.0056616 | 0.0 | 0.06 +Comm | 0.0022387 | 0.0022387 | 0.0022387 | 0.0 | 0.02 +Output | 0.013878 | 0.013878 | 0.013878 | 0.0 | 0.14 +Modify | 0.00062189 | 0.00062189 | 0.00062189 | 0.0 | 0.01 +Other | | 0.0007035 | | | 0.01 + +Nlocal: 648 ave 648 max 648 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 4282 ave 4282 max 4282 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 98490 ave 98490 max 98490 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 98490 +Ave neighs/atom = 151.99074 +Ave special neighs/atom = 2 +Neighbor list builds = 2 +Dangerous builds = 0 +Total wall time: 0:00:10 diff --git a/examples/amoeba/log.water_box.hippo.32 b/examples/amoeba/log.water_box.hippo.32 new file mode 100644 index 0000000000..7686b5fd25 --- /dev/null +++ b/examples/amoeba/log.water_box.hippo.32 @@ -0,0 +1,153 @@ +LAMMPS (24 Mar 2022) +# water box with AMOEBA or HIPPO + +units real +boundary p p p + +atom_style amoeba +bond_style class2 +angle_style amoeba +dihedral_style none + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes +fix extra2 all property/atom i_polaxe + +# read data file + +read_data data.water_box.hippo fix amtype NULL "Tinker Types" +Reading data file ... + orthogonal box = (0 0 0) to (18.643 18.643 18.643) + 2 by 4 by 4 MPI processor grid + reading atoms ... + 648 atoms + scanning bonds ... + 2 = max bonds/atom + scanning angles ... + 1 = max angles/atom + reading bonds ... + 432 bonds + reading angles ... + 216 angles +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.002 seconds + read_data CPU = 0.027 seconds + +# force field + +pair_style hippo +pair_coeff * * hippo_water.prm hippo_water_box.key + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0.5 0.5 0.5 + special bond factors coul: 0.5 0.5 0.5 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of 1-5 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.002 seconds + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] + +dump 1 all custom 10 dump.water_box id type x y z fx fy fz +dump_modify 1 sort id + +# zero step run + +#run 0 + +# dynamics + +fix 1 all nve + +thermo 10 +run 100 +AMOEBA/HIPPO force field settings + repulsion: cut 7 taper 6 rscale 0 0 1 1 + qxfer: cut 7 taper 6 mscale 0 0 0.4 1 + dispersion: cut 7 aewald 0.45 bsorder 4 FFT 16 16 16 dspscale 0 0 0.4 1 + multipole: cut 7 aewald 0.4 bsorder 5 FFT 24 24 24 mscale 0 0 0.4 1 + polar: cut 7 aewald 0.5 bsorder 5 FFT 24 24 24 + pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 0.2 1 1 1 d/u scale 0 1 + precondition: cut 4.5 + generated 0 of 1 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 9 + ghost atom cutoff = 9 + binsize = 4.5, bins = 5 5 5 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair hippo, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d + bin: standard + AMOEBA/HIPPO group count: 216 +Per MPI rank memory allocation (min/avg/max) = 10.07 | 10.08 | 10.34 Mbytes + Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] + 0 0 -2188.594 166.82637 77.478353 0 0 244.30473 -1944.2893 -10859.589 -9285.4645 -11598.049 -11695.254 -282.7072 3164.4148 2495.2578 + 10 100.94691 -2350.192 116.13156 88.56605 0 0 204.69761 -1950.8098 -11480.919 -13574.139 -12190.797 -12798.212 -263.77028 280.62864 1974.1486 + 20 153.91622 -2358.3058 36.396961 66.22466 0 0 102.62162 -1958.8438 -7778.4529 -8492.3868 -11999.431 -9125.9998 -917.99962 589.09064 1788.2094 + 30 145.5951 -2343.9956 39.651541 65.833248 0 0 105.48479 -1957.7184 -288.79965 -2574.4466 -3820.4824 -414.28285 -347.51491 -1147.3995 -126.71025 + 40 126.87801 -2340.2623 102.93951 43.896946 0 0 146.83646 -1948.7309 6766.15 5908.7048 1280.0961 7930.8191 -1085.6811 -1596.6859 -714.82888 + 50 134.52078 -2358.9232 107.49288 44.253826 0 0 151.74671 -1947.7419 8762.4348 6023.4661 5377.0189 9396.0316 -1629.1364 -1663.1666 -2381.51 + 60 173.10181 -2374.3854 51.097314 33.03646 0 0 84.133774 -1956.4102 4614.2907 1719.1989 505.79149 4552.3167 -1661.1714 -587.92108 -1380.6732 + 70 184.86849 -2391.6106 39.916931 35.978152 0 0 75.895083 -1959.1811 -2146.9339 -4993.4021 -4095.6729 -4897.5768 -833.09046 1542.411 -1539.5266 + 80 164.75795 -2406.3017 101.94229 33.067832 0 0 135.01013 -1953.542 -8779.3265 -10545.409 -10418.702 -12098.858 -1319.194 1750.3511 -275.1272 + 90 151.17491 -2434.6876 152.21826 41.301673 0 0 193.51993 -1949.6141 -13330.691 -15436.505 -13791.461 -16934.674 149.25497 2289.1026 976.14333 + +AMEOBA/HIPPO timing info: + Init time: 0.0225211 0.0138448 + Repls time: 0.0710727 4.36919 + Disp time: 0.147228 9.05085 + Mpole time: 0.271419 16.6855 + Induce time: 0.760323 46.7408 + Polar time: 0.341361 20.9851 + Qxfer time: 0.0127489 0.783737 + Total time: 1.62668 + + 100 166.99163 -2452.5298 143.57768 35.341459 0 0 178.91914 -1951.5533 -14918.51 -16077.49 -17353.738 -18140.466 19.009088 1487.0469 1084.0231 +Loop time of 1.65072 on 32 procs for 100 steps with 648 atoms + +Performance: 5.234 ns/day, 4.585 hours/ns, 60.579 timesteps/s +99.7% CPU use with 32 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 1.6233 | 1.6277 | 1.632 | 0.2 | 98.61 +Bond | 0.0001841 | 0.00025145 | 0.00041274 | 0.0 | 0.02 +Neigh | 0.00046301 | 0.00052361 | 0.00059181 | 0.0 | 0.03 +Comm | 0.013032 | 0.017446 | 0.021961 | 1.7 | 1.06 +Output | 0.0035779 | 0.0036051 | 0.0038143 | 0.1 | 0.22 +Modify | 0.00011362 | 0.00018386 | 0.0002631 | 0.0 | 0.01 +Other | | 0.0009717 | | | 0.06 + +Nlocal: 20.25 ave 27 max 12 min +Histogram: 1 1 3 1 6 2 10 4 2 2 +Nghost: 1379.75 ave 1408 max 1345 min +Histogram: 2 4 1 3 3 4 4 3 2 6 +Neighs: 3077.81 ave 4233 max 1858 min +Histogram: 1 3 1 4 5 7 6 2 1 2 + +Total # of neighbors = 98490 +Ave neighs/atom = 151.99074 +Ave special neighs/atom = 2 +Neighbor list builds = 2 +Dangerous builds = 0 +Total wall time: 0:00:01 diff --git a/examples/amoeba/log.water_dimer.amoeba.1 b/examples/amoeba/log.water_dimer.amoeba.1 new file mode 100644 index 0000000000..869e0c0eff --- /dev/null +++ b/examples/amoeba/log.water_dimer.amoeba.1 @@ -0,0 +1,150 @@ +LAMMPS (24 Mar 2022) +# water dimer with AMOEBA or HIPPO + +units real +boundary s s s + +atom_style amoeba +bond_style class2 +angle_style amoeba +dihedral_style none + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes +fix extra2 all property/atom i_polaxe + +# read data file + +read_data data.water_dimer.amoeba fix amtype NULL "Tinker Types" +Reading data file ... + orthogonal box = (-1.463996 -0.756549 -0.009705) to (0.933234 0.75612 2.935934) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 6 atoms + scanning bonds ... + 2 = max bonds/atom + scanning angles ... + 1 = max angles/atom + reading bonds ... + 4 bonds + reading angles ... + 2 angles +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + read_data CPU = 0.007 seconds + +# force field + +pair_style amoeba +pair_coeff * * amoeba_water.prm amoeba_water.key + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0.5 0.5 0.5 + special bond factors coul: 0.5 0.5 0.5 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of 1-5 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] + +dump 1 all custom 10 dump.water_dimer id type x y z fx fy fz +dump_modify 1 sort id + +# zero step run + +#run 0 + +# dynamics + +fix 1 all nve + +thermo 10 +run 100 +AMOEBA/HIPPO force field settings + hal: cut 10 taper 8 vscale 0 0 1 1 + multipole: cut 10 aewald 0 mscale 0 0 0.4 1 + polar: cut 10 aewald 0 + pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 1 1 1 1 d/u scale 0 1 + precondition: cut 4.5 + generated 0 of 1 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 12 + ghost atom cutoff = 12 + binsize = 6, bins = 1 1 1 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair amoeba, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d + bin: standard +WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (../domain.cpp:974) + AMOEBA/HIPPO group count: 2 +Per MPI rank memory allocation (min/avg/max) = 9.855 | 9.855 | 9.855 Mbytes + Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] + 0 0 -5.1627563 0.025695395 0.71581114 0 0 0.74150653 -4.4212497 -12260.522 -43226.042 39448.214 -33003.739 -85.160886 -28101.905 -72.971988 + 10 1.1174766 -4.7928792 0.045080327 0.30848527 0 0 0.35356559 -4.4226587 -14728.416 11456.119 -52592.829 -3262.8454 70.868937 29494.268 57.977562 + 20 3.0821934 -5.1387316 0.013108182 0.65694692 0 0 0.6700551 -4.4227393 3007.4148 -25925.326 49641.41 -15284.933 -79.726771 -29005.234 -68.530079 + 30 3.461967 -4.8079248 0.013888863 0.31895667 0 0 0.33284554 -4.423482 8616.211 40027.877 -31134.295 16291.126 72.510013 23088.238 51.407946 + 40 4.2181367 -5.0535921 0.0099009766 0.55796811 0 0 0.56786908 -4.4228557 24239.885 -5761.6967 62095.735 15576.675 -76.240192 -33057.385 -58.850871 + 50 5.216657 -4.8012751 0.0053003148 0.29489399 0 0 0.30019431 -4.4233315 17728.056 44785.731 -21215.714 28613.715 66.24671 20292.137 51.010856 + 60 9.45101 -5.0818046 0.0043357361 0.5118733 0 0 0.51620903 -4.4247372 16893.135 -15068.961 50111.11 13824.77 -75.966047 -34809.168 -52.83183 + 70 10.385926 -4.8250769 0.022572262 0.22235766 0 0 0.24492992 -4.4253547 -1117.3665 19070.918 -36063.612 11648.813 61.067533 25754.59 53.919881 + 80 12.797691 -5.123735 0.023756795 0.48275385 0 0 0.50651065 -4.4264869 -6491.9826 -28436.037 20681.908 -14176.121 -64.024669 -35737.052 -52.583533 + 90 12.569481 -4.8303379 0.060369422 0.15670502 0 0 0.21707444 -4.4259273 -16762.536 1720.5855 -47624.986 -6793.7441 59.966729 30024.566 52.339671 + +AMEOBA/HIPPO timing info: + Init time: 0.000126119 0.0205557 + Hal time: 0.000487693 7.94875 + Mpole time: 0.00066233 10.7951 + Induce time: 0.00328101 53.4761 + Polar time: 0.0015627 25.4699 + Total time: 0.00613547 + + 100 17.750788 -5.1195235 0.039885925 0.38711474 0 0 0.42700067 -4.4279642 -10817.92 -21833.456 4186.8301 -18211.329 -43.11086 -32664.671 -41.508916 +Loop time of 0.00720187 on 1 procs for 100 steps with 6 atoms + +Performance: 1199.688 ns/day, 0.020 hours/ns, 13885.283 timesteps/s +83.0% CPU use with 1 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.0062208 | 0.0062208 | 0.0062208 | 0.0 | 86.38 +Bond | 0.00010381 | 0.00010381 | 0.00010381 | 0.0 | 1.44 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 1.4955e-05 | 1.4955e-05 | 1.4955e-05 | 0.0 | 0.21 +Output | 0.00075216 | 0.00075216 | 0.00075216 | 0.0 | 10.44 +Modify | 4.5409e-05 | 4.5409e-05 | 4.5409e-05 | 0.0 | 0.63 +Other | | 6.472e-05 | | | 0.90 + +Nlocal: 6 ave 6 max 6 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 0 ave 0 max 0 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 15 ave 15 max 15 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 15 +Ave neighs/atom = 2.5 +Ave special neighs/atom = 2 +Neighbor list builds = 0 +Dangerous builds = 0 +Total wall time: 0:00:00 diff --git a/examples/amoeba/log.water_dimer.amoeba.4 b/examples/amoeba/log.water_dimer.amoeba.4 new file mode 100644 index 0000000000..e5396339d9 --- /dev/null +++ b/examples/amoeba/log.water_dimer.amoeba.4 @@ -0,0 +1,150 @@ +LAMMPS (24 Mar 2022) +# water dimer with AMOEBA or HIPPO + +units real +boundary s s s + +atom_style amoeba +bond_style class2 +angle_style amoeba +dihedral_style none + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes +fix extra2 all property/atom i_polaxe + +# read data file + +read_data data.water_dimer.amoeba fix amtype NULL "Tinker Types" +Reading data file ... + orthogonal box = (-1.463996 -0.756549 -0.009705) to (0.933234 0.75612 2.935934) + 2 by 1 by 2 MPI processor grid + reading atoms ... + 6 atoms + scanning bonds ... + 2 = max bonds/atom + scanning angles ... + 1 = max angles/atom + reading bonds ... + 4 bonds + reading angles ... + 2 angles +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + read_data CPU = 0.009 seconds + +# force field + +pair_style amoeba +pair_coeff * * amoeba_water.prm amoeba_water.key + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0.5 0.5 0.5 + special bond factors coul: 0.5 0.5 0.5 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of 1-5 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.001 seconds + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] + +dump 1 all custom 10 dump.water_dimer id type x y z fx fy fz +dump_modify 1 sort id + +# zero step run + +#run 0 + +# dynamics + +fix 1 all nve + +thermo 10 +run 100 +AMOEBA/HIPPO force field settings + hal: cut 10 taper 8 vscale 0 0 1 1 + multipole: cut 10 aewald 0 mscale 0 0 0.4 1 + polar: cut 10 aewald 0 + pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 1 1 1 1 d/u scale 0 1 + precondition: cut 4.5 + generated 0 of 1 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 12 + ghost atom cutoff = 12 + binsize = 6, bins = 1 1 1 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair amoeba, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d + bin: standard +WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (../domain.cpp:974) + AMOEBA/HIPPO group count: 2 +Per MPI rank memory allocation (min/avg/max) = 9.883 | 10.02 | 10.15 Mbytes + Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] + 0 0 -5.1627563 0.025695395 0.71581114 0 0 0.74150653 -4.4212497 -12260.522 -43226.042 39448.214 -33003.739 -85.160886 -28101.905 -72.971988 + 10 1.1174766 -4.7928792 0.045080327 0.30848527 0 0 0.35356559 -4.4226587 -14728.416 11456.119 -52592.829 -3262.8454 70.868937 29494.268 57.977562 + 20 3.0821934 -5.1387316 0.013108182 0.65694692 0 0 0.6700551 -4.4227393 3007.4148 -25925.326 49641.41 -15284.933 -79.726771 -29005.234 -68.530079 + 30 3.461967 -4.8079248 0.013888863 0.31895667 0 0 0.33284554 -4.423482 8616.211 40027.877 -31134.295 16291.126 72.510013 23088.238 51.407946 + 40 4.2181367 -5.0535921 0.0099009766 0.55796811 0 0 0.56786908 -4.4228557 24239.885 -5761.6967 62095.735 15576.675 -76.240192 -33057.385 -58.850871 + 50 5.216657 -4.8012751 0.0053003148 0.29489399 0 0 0.30019431 -4.4233315 17728.056 44785.731 -21215.714 28613.715 66.24671 20292.137 51.010856 + 60 9.45101 -5.0818046 0.0043357361 0.5118733 0 0 0.51620903 -4.4247372 16893.135 -15068.961 50111.11 13824.77 -75.966047 -34809.168 -52.83183 + 70 10.385926 -4.8250769 0.022572262 0.22235766 0 0 0.24492992 -4.4253547 -1117.3665 19070.918 -36063.612 11648.813 61.067533 25754.59 53.919881 + 80 12.797691 -5.123735 0.023756795 0.48275385 0 0 0.50651065 -4.4264869 -6491.9826 -28436.037 20681.908 -14176.121 -64.024669 -35737.052 -52.583533 + 90 12.569481 -4.8303379 0.060369422 0.15670502 0 0 0.21707444 -4.4259273 -16762.536 1720.5855 -47624.986 -6793.7441 59.966729 30024.566 52.339671 + +AMEOBA/HIPPO timing info: + Init time: 0.000562834 0.0392455 + Hal time: 0.000119032 0.829992 + Mpole time: 0.000759989 5.29928 + Induce time: 0.0118027 82.2984 + Polar time: 0.00108262 7.54891 + Total time: 0.0143414 + + 100 17.750788 -5.1195235 0.039885925 0.38711474 0 0 0.42700067 -4.4279642 -10817.92 -21833.456 4186.8301 -18211.329 -43.11086 -32664.671 -41.508916 +Loop time of 0.0169266 on 4 procs for 100 steps with 6 atoms + +Performance: 510.439 ns/day, 0.047 hours/ns, 5907.863 timesteps/s +99.7% CPU use with 4 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.014229 | 0.01457 | 0.014803 | 0.2 | 86.08 +Bond | 1.311e-05 | 4.1295e-05 | 6.8411e-05 | 0.0 | 0.24 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.00067827 | 0.0008315 | 0.0011965 | 0.0 | 4.91 +Output | 0.00094515 | 0.0010124 | 0.0011247 | 0.2 | 5.98 +Modify | 2.1384e-05 | 4.0305e-05 | 5.4006e-05 | 0.0 | 0.24 +Other | | 0.0004309 | | | 2.55 + +Nlocal: 1.5 ave 3 max 0 min +Histogram: 2 0 0 0 0 0 0 0 0 2 +Nghost: 4.5 ave 6 max 3 min +Histogram: 2 0 0 0 0 0 0 0 0 2 +Neighs: 3.75 ave 12 max 0 min +Histogram: 2 0 1 0 0 0 0 0 0 1 + +Total # of neighbors = 15 +Ave neighs/atom = 2.5 +Ave special neighs/atom = 2 +Neighbor list builds = 0 +Dangerous builds = 0 +Total wall time: 0:00:00 diff --git a/examples/amoeba/log.water_dimer.hippo.1 b/examples/amoeba/log.water_dimer.hippo.1 new file mode 100644 index 0000000000..313c462c72 --- /dev/null +++ b/examples/amoeba/log.water_dimer.hippo.1 @@ -0,0 +1,154 @@ +LAMMPS (24 Mar 2022) +# water dimer with AMOEBA or HIPPO + +units real +boundary s s s + +atom_style amoeba +bond_style class2 +angle_style amoeba +dihedral_style none + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes +fix extra2 all property/atom i_polaxe + +# read data file + +read_data data.water_dimer.hippo fix amtype NULL "Tinker Types" +Reading data file ... + orthogonal box = (-1.463996 -0.756549 -0.009705) to (0.933234 0.75612 2.935934) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 6 atoms + scanning bonds ... + 2 = max bonds/atom + scanning angles ... + 1 = max angles/atom + reading bonds ... + 4 bonds + reading angles ... + 2 angles +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + read_data CPU = 0.007 seconds + +# force field + +pair_style hippo +pair_coeff * * hippo_water.prm hippo_water.key + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0.5 0.5 0.5 + special bond factors coul: 0.5 0.5 0.5 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of 1-5 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] + +dump 1 all custom 10 dump.water_dimer id type x y z fx fy fz +dump_modify 1 sort id + +# zero step run + +#run 0 + +# dynamics + +fix 1 all nve + +thermo 10 +run 100 +AMOEBA/HIPPO force field settings + repulsion: cut 10 taper 8 rscale 0 0 1 1 + qxfer: cut 10 taper 8 mscale 0 0 0.4 1 + dispersion: cut 10 aewald 0 dspscale 0 0 0.4 1 + multipole: cut 10 aewald 0 mscale 0 0 0.4 1 + polar: cut 10 aewald 0 + pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 0.2 1 1 1 d/u scale 0 1 + precondition: cut 4.5 + generated 0 of 1 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 12 + ghost atom cutoff = 12 + binsize = 6, bins = 1 1 1 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair hippo, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d + bin: standard +WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (../domain.cpp:974) + AMOEBA/HIPPO group count: 2 +Per MPI rank memory allocation (min/avg/max) = 9.855 | 9.855 | 9.855 Mbytes + Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] + 0 0 -5.0101954 0.025695395 0.51472748 0 0 0.54042288 -4.4697726 -11875.159 -38149.178 29162.678 -26638.977 -70.63422 -24614.614 -58.505595 + 10 0.75132894 -4.7952077 0.028216017 0.28494196 0 0 0.31315798 -4.4708519 -13243.822 12661.254 -49613.657 -2923.1497 69.449413 29456.684 56.087663 + 20 2.1716525 -5.0036265 0.011809223 0.48875837 0 0 0.50056759 -4.4706925 4371.5298 -22102.532 47044.297 -12243.648 -74.588915 -28903.762 -64.48154 + 30 2.9930198 -4.8261906 0.0091463366 0.30162756 0 0 0.3107739 -4.4708086 9992.4549 41973.539 -20985.339 8415.1715 67.458145 25027.414 40.261795 + 40 3.312268 -4.9802484 0.010400667 0.45076258 0 0 0.46116325 -4.4697189 21565.307 -11602.414 65186.215 10476.902 -83.374203 -33222.094 -64.700001 + 50 4.3187397 -4.8535614 0.0060313545 0.31244652 0 0 0.31847788 -4.4707168 11344.244 45839.35 -21073.749 8438.8954 73.345039 29422.636 43.897876 + 60 4.9127902 -5.0035271 0.0070589202 0.45246538 0 0 0.4595243 -4.4707824 6529.9354 -37107.891 46740.24 9015.2973 -90.41111 -34402.095 -53.57079 + 70 5.3145827 -4.8748857 0.025797484 0.29875503 0 0 0.32455252 -4.4711244 -10208.876 26324.134 -49272.688 -8697.2875 84.479942 36185.667 57.000355 + 80 3.8409793 -5.0262066 0.027669388 0.47104466 0 0 0.49871405 -4.4702464 -9777.1809 -52088.554 28053.855 -6033.4555 -94.607853 -44638.417 -59.108505 + 90 3.0683704 -4.8369716 0.035455716 0.28466932 0 0 0.32012503 -4.4711155 -10626.245 31066.635 -49425.925 -14107.889 87.765958 34632.905 52.101981 + +AMEOBA/HIPPO timing info: + Init time: 0.000114914 0.0215289 + Repls time: 0.000617533 11.5693 + Disp time: 0.000365952 6.85603 + Mpole time: 0.000944495 17.6949 + Induce time: 0.00199722 37.4176 + Polar time: 0.0011473 21.4944 + Qxfer time: 0.000145366 2.7234 + Total time: 0.00533767 + + 100 3.5262799 -4.9906817 0.016687539 0.45011301 0 0 0.46680055 -4.4713252 5216.7691 -34991.221 43883.163 6082.1058 -95.830393 -48645.129 -64.784334 +Loop time of 0.0063791 on 1 procs for 100 steps with 6 atoms + +Performance: 1354.423 ns/day, 0.018 hours/ns, 15676.190 timesteps/s +98.9% CPU use with 1 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.005435 | 0.005435 | 0.005435 | 0.0 | 85.20 +Bond | 8.7439e-05 | 8.7439e-05 | 8.7439e-05 | 0.0 | 1.37 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 1.447e-05 | 1.447e-05 | 1.447e-05 | 0.0 | 0.23 +Output | 0.00073302 | 0.00073302 | 0.00073302 | 0.0 | 11.49 +Modify | 4.6662e-05 | 4.6662e-05 | 4.6662e-05 | 0.0 | 0.73 +Other | | 6.248e-05 | | | 0.98 + +Nlocal: 6 ave 6 max 6 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 0 ave 0 max 0 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 15 ave 15 max 15 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 15 +Ave neighs/atom = 2.5 +Ave special neighs/atom = 2 +Neighbor list builds = 0 +Dangerous builds = 0 +Total wall time: 0:00:00 diff --git a/examples/amoeba/log.water_dimer.hippo.4 b/examples/amoeba/log.water_dimer.hippo.4 new file mode 100644 index 0000000000..a56de55964 --- /dev/null +++ b/examples/amoeba/log.water_dimer.hippo.4 @@ -0,0 +1,154 @@ +LAMMPS (24 Mar 2022) +# water dimer with AMOEBA or HIPPO + +units real +boundary s s s + +atom_style amoeba +bond_style class2 +angle_style amoeba +dihedral_style none + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes +fix extra2 all property/atom i_polaxe + +# read data file + +read_data data.water_dimer.hippo fix amtype NULL "Tinker Types" +Reading data file ... + orthogonal box = (-1.463996 -0.756549 -0.009705) to (0.933234 0.75612 2.935934) + 2 by 1 by 2 MPI processor grid + reading atoms ... + 6 atoms + scanning bonds ... + 2 = max bonds/atom + scanning angles ... + 1 = max angles/atom + reading bonds ... + 4 bonds + reading angles ... + 2 angles +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + read_data CPU = 0.009 seconds + +# force field + +pair_style hippo +pair_coeff * * hippo_water.prm hippo_water.key + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0.5 0.5 0.5 + special bond factors coul: 0.5 0.5 0.5 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of 1-5 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.001 seconds + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] + +dump 1 all custom 10 dump.water_dimer id type x y z fx fy fz +dump_modify 1 sort id + +# zero step run + +#run 0 + +# dynamics + +fix 1 all nve + +thermo 10 +run 100 +AMOEBA/HIPPO force field settings + repulsion: cut 10 taper 8 rscale 0 0 1 1 + qxfer: cut 10 taper 8 mscale 0 0 0.4 1 + dispersion: cut 10 aewald 0 dspscale 0 0 0.4 1 + multipole: cut 10 aewald 0 mscale 0 0 0.4 1 + polar: cut 10 aewald 0 + pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 0.2 1 1 1 d/u scale 0 1 + precondition: cut 4.5 + generated 0 of 1 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 12 + ghost atom cutoff = 12 + binsize = 6, bins = 1 1 1 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair hippo, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d + bin: standard +WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (../domain.cpp:974) + AMOEBA/HIPPO group count: 2 +Per MPI rank memory allocation (min/avg/max) = 9.883 | 10.02 | 10.15 Mbytes + Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] + 0 0 -5.0101954 0.025695395 0.51472748 0 0 0.54042288 -4.4697726 -11875.159 -38149.178 29162.678 -26638.977 -70.63422 -24614.614 -58.505595 + 10 0.75132894 -4.7952077 0.028216017 0.28494196 0 0 0.31315798 -4.4708519 -13243.822 12661.254 -49613.657 -2923.1497 69.449413 29456.684 56.087663 + 20 2.1716525 -5.0036265 0.011809223 0.48875837 0 0 0.50056759 -4.4706925 4371.5298 -22102.532 47044.297 -12243.648 -74.588915 -28903.762 -64.48154 + 30 2.9930198 -4.8261906 0.0091463366 0.30162756 0 0 0.3107739 -4.4708086 9992.4549 41973.539 -20985.339 8415.1715 67.458145 25027.414 40.261795 + 40 3.312268 -4.9802484 0.010400667 0.45076258 0 0 0.46116325 -4.4697189 21565.307 -11602.414 65186.215 10476.902 -83.374203 -33222.094 -64.700001 + 50 4.3187397 -4.8535614 0.0060313545 0.31244652 0 0 0.31847788 -4.4707168 11344.244 45839.35 -21073.749 8438.8954 73.345039 29422.636 43.897876 + 60 4.9127902 -5.0035271 0.0070589202 0.45246538 0 0 0.4595243 -4.4707824 6529.9354 -37107.891 46740.24 9015.2973 -90.41111 -34402.095 -53.57079 + 70 5.3145827 -4.8748857 0.025797484 0.29875503 0 0 0.32455252 -4.4711244 -10208.876 26324.134 -49272.688 -8697.2875 84.479942 36185.667 57.000355 + 80 3.8409793 -5.0262066 0.027669388 0.47104466 0 0 0.49871405 -4.4702464 -9777.1809 -52088.554 28053.855 -6033.4555 -94.607853 -44638.417 -59.108505 + 90 3.0683704 -4.8369716 0.035455716 0.28466932 0 0 0.32012503 -4.4711155 -10626.245 31066.635 -49425.925 -14107.889 87.765958 34632.905 52.101981 + +AMEOBA/HIPPO timing info: + Init time: 0.000628997 0.0480375 + Repls time: 0.000859377 6.5632 + Disp time: 0.00015718 1.20041 + Mpole time: 0.00153385 11.7143 + Induce time: 0.0085554 65.339 + Polar time: 0.00127985 9.77439 + Qxfer time: 7.40915e-05 0.565849 + Total time: 0.0130939 + + 100 3.5262799 -4.9906817 0.016687539 0.45011301 0 0 0.46680055 -4.4713252 5216.7691 -34991.221 43883.163 6082.1058 -95.830393 -48645.129 -64.784334 +Loop time of 0.0163786 on 4 procs for 100 steps with 6 atoms + +Performance: 527.519 ns/day, 0.045 hours/ns, 6105.545 timesteps/s +98.7% CPU use with 4 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.012747 | 0.013356 | 0.013763 | 0.3 | 81.55 +Bond | 1.4562e-05 | 5.3301e-05 | 0.00010757 | 0.0 | 0.33 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.00061214 | 0.001076 | 0.0015518 | 1.0 | 6.57 +Output | 0.0011991 | 0.0013282 | 0.0015124 | 0.3 | 8.11 +Modify | 2.2511e-05 | 3.8778e-05 | 5.1854e-05 | 0.0 | 0.24 +Other | | 0.0005259 | | | 3.21 + +Nlocal: 1.5 ave 3 max 0 min +Histogram: 2 0 0 0 0 0 0 0 0 2 +Nghost: 4.5 ave 6 max 3 min +Histogram: 2 0 0 0 0 0 0 0 0 2 +Neighs: 3.75 ave 12 max 0 min +Histogram: 2 0 1 0 0 0 0 0 0 1 + +Total # of neighbors = 15 +Ave neighs/atom = 2.5 +Ave special neighs/atom = 2 +Neighbor list builds = 0 +Dangerous builds = 0 +Total wall time: 0:00:00 diff --git a/examples/amoeba/log.water_hexamer.amoeba.1 b/examples/amoeba/log.water_hexamer.amoeba.1 new file mode 100644 index 0000000000..af23d3ff82 --- /dev/null +++ b/examples/amoeba/log.water_hexamer.amoeba.1 @@ -0,0 +1,149 @@ +LAMMPS (24 Mar 2022) +# water hexamer with AMOEBA or HIPPO + +units real +boundary s s s + +atom_style amoeba +bond_style class2 +angle_style amoeba +dihedral_style none + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes +fix extra2 all property/atom i_polaxe + +# read data file + +read_data data.water_hexamer.amoeba fix amtype NULL "Tinker Types" +Reading data file ... + orthogonal box = (-2.517835 -1.523041 -1.734766) to (2.675716 2.01883 2.220847) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 18 atoms + scanning bonds ... + 2 = max bonds/atom + scanning angles ... + 1 = max angles/atom + reading bonds ... + 12 bonds + reading angles ... + 6 angles +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + read_data CPU = 0.007 seconds + +# force field + +pair_style amoeba +pair_coeff * * amoeba_water.prm amoeba_water.key + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0.5 0.5 0.5 + special bond factors coul: 0.5 0.5 0.5 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of 1-5 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] + +dump 1 all custom 10 dump.water_hexamer id type x y z fx fy fz +dump_modify 1 sort id + +# zero step run + +#run 0 + +# dynamics + +fix 1 all nve + +thermo 10 +run 100 +AMOEBA/HIPPO force field settings + hal: cut 10 taper 8 vscale 0 0 1 1 + multipole: cut 10 aewald 0 mscale 0 0 0.4 1 + polar: cut 10 aewald 0 + pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 1 1 1 1 d/u scale 0 1 + precondition: cut 4.5 + generated 0 of 1 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 12 + ghost atom cutoff = 12 + binsize = 6, bins = 1 1 1 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair amoeba, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d + bin: standard + AMOEBA/HIPPO group count: 6 +Per MPI rank memory allocation (min/avg/max) = 9.804 | 9.804 | 9.804 Mbytes + Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] + 0 0 -48.469664 1.9820353 2.2499329 0 0 4.2319683 -44.237696 -26322.671 -28303.103 -27669.614 -22995.296 1312.6688 2624.8394 4042.0489 + 10 6.3616471 -46.626437 1.7910812 0.25704063 0 0 2.0481218 -44.255947 -23813.06 -24671.886 -17167.34 -30208.043 -474.208 -8339.5934 -5278.359 + 20 15.149798 -48.177533 1.1130818 2.007499 0 0 3.1205807 -44.289255 -16468.855 -20150.975 -18596.629 -12107.083 885.52697 6320.1867 3064.949 + 30 17.896968 -45.959274 0.54802739 0.19519937 0 0 0.74322676 -44.309141 -4749.0624 -9053.7792 -182.37209 -6721.7499 -2003.7641 -627.56998 -1658.1301 + 40 16.203813 -46.840973 0.1371751 1.5793326 0 0 1.7165077 -44.303357 9267.4858 6108.7966 4116.4548 16028.336 380.03787 8468.0648 4492.3331 + 50 11.584975 -45.166711 0.017120512 0.28622888 0 0 0.30334939 -44.276308 22189.511 21453.083 22339.471 21668.607 150.93139 1059.5253 200.0668 + 60 10.002055 -45.994946 0.037889337 1.1987062 0 0 1.2365956 -44.251509 30944.004 35801.925 19832.696 36241.326 2042.3054 2320.5193 1660.0834 + 70 11.272241 -45.411622 0.07431614 0.51778317 0 0 0.59209931 -44.248316 32055.564 39306.193 30181.52 25601.501 1373.4778 -4501.0686 -2570.4767 + 80 14.011502 -46.081444 0.089688317 1.006928 0 0 1.0966163 -44.274812 25661.838 38836.598 12603.734 24205.867 -867.36437 -4211.9639 -2820.6725 + 90 17.659498 -46.247295 0.21744649 0.82687716 0 0 1.0443237 -44.308098 12101.207 19426.995 14142.311 1046.299 -2157.5418 -2141.2454 -2621.456 + +AMEOBA/HIPPO timing info: + Init time: 0.000298703 0.00766228 + Hal time: 0.00477252 12.2424 + Mpole time: 0.00429886 11.0274 + Induce time: 0.0189419 48.5895 + Polar time: 0.0106573 27.338 + Total time: 0.0389836 + + 100 17.630532 -46.788272 0.61811601 0.9654966 0 0 1.5836126 -44.311254 -4455.3587 3961.5737 -11554.095 -7458.8012 -3120.9771 -1532.1706 -1499.0117 +Loop time of 0.0403763 on 1 procs for 100 steps with 18 atoms + +Performance: 213.987 ns/day, 0.112 hours/ns, 2476.699 timesteps/s +96.9% CPU use with 1 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.039062 | 0.039062 | 0.039062 | 0.0 | 96.74 +Bond | 0.00018661 | 0.00018661 | 0.00018661 | 0.0 | 0.46 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 1.665e-05 | 1.665e-05 | 1.665e-05 | 0.0 | 0.04 +Output | 0.0009741 | 0.0009741 | 0.0009741 | 0.0 | 2.41 +Modify | 6.7026e-05 | 6.7026e-05 | 6.7026e-05 | 0.0 | 0.17 +Other | | 7.005e-05 | | | 0.17 + +Nlocal: 18 ave 18 max 18 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 0 ave 0 max 0 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 153 ave 153 max 153 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 153 +Ave neighs/atom = 8.5 +Ave special neighs/atom = 2 +Neighbor list builds = 0 +Dangerous builds = 0 +Total wall time: 0:00:00 diff --git a/examples/amoeba/log.water_hexamer.amoeba.4 b/examples/amoeba/log.water_hexamer.amoeba.4 new file mode 100644 index 0000000000..a76513acad --- /dev/null +++ b/examples/amoeba/log.water_hexamer.amoeba.4 @@ -0,0 +1,150 @@ +LAMMPS (24 Mar 2022) +# water hexamer with AMOEBA or HIPPO + +units real +boundary s s s + +atom_style amoeba +bond_style class2 +angle_style amoeba +dihedral_style none + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes +fix extra2 all property/atom i_polaxe + +# read data file + +read_data data.water_hexamer.amoeba fix amtype NULL "Tinker Types" +Reading data file ... + orthogonal box = (-2.517835 -1.523041 -1.734766) to (2.675716 2.01883 2.220847) + 2 by 1 by 2 MPI processor grid + reading atoms ... + 18 atoms + scanning bonds ... + 2 = max bonds/atom + scanning angles ... + 1 = max angles/atom + reading bonds ... + 12 bonds + reading angles ... + 6 angles +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.001 seconds + read_data CPU = 0.009 seconds + +# force field + +pair_style amoeba +pair_coeff * * amoeba_water.prm amoeba_water.key + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0.5 0.5 0.5 + special bond factors coul: 0.5 0.5 0.5 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of 1-5 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.001 seconds + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] + +dump 1 all custom 10 dump.water_hexamer id type x y z fx fy fz +dump_modify 1 sort id + +# zero step run + +#run 0 + +# dynamics + +fix 1 all nve + +thermo 10 +run 100 +AMOEBA/HIPPO force field settings + hal: cut 10 taper 8 vscale 0 0 1 1 + multipole: cut 10 aewald 0 mscale 0 0 0.4 1 + polar: cut 10 aewald 0 + pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 1 1 1 1 d/u scale 0 1 + precondition: cut 4.5 + generated 0 of 1 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 12 + ghost atom cutoff = 12 + binsize = 6, bins = 1 1 1 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair amoeba, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d + bin: standard +WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (../domain.cpp:974) + AMOEBA/HIPPO group count: 6 +Per MPI rank memory allocation (min/avg/max) = 9.833 | 9.833 | 9.833 Mbytes + Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] + 0 0 -48.469664 1.9820353 2.2499329 0 0 4.2319683 -44.237696 -26322.671 -28303.103 -27669.614 -22995.296 1312.6688 2624.8394 4042.0489 + 10 6.3616471 -46.626437 1.7910812 0.25704063 0 0 2.0481218 -44.255947 -23813.06 -24671.886 -17167.34 -30208.043 -474.208 -8339.5934 -5278.359 + 20 15.149798 -48.177533 1.1130818 2.007499 0 0 3.1205807 -44.289255 -16468.855 -20150.975 -18596.629 -12107.083 885.52697 6320.1867 3064.949 + 30 17.896968 -45.959274 0.54802739 0.19519937 0 0 0.74322676 -44.309141 -4749.0624 -9053.7792 -182.37209 -6721.7499 -2003.7641 -627.56998 -1658.1301 + 40 16.203813 -46.840973 0.1371751 1.5793326 0 0 1.7165077 -44.303357 9267.4858 6108.7966 4116.4548 16028.336 380.03787 8468.0648 4492.3331 + 50 11.584975 -45.166711 0.017120512 0.28622888 0 0 0.30334939 -44.276308 22189.511 21453.083 22339.471 21668.607 150.93139 1059.5253 200.0668 + 60 10.002055 -45.994946 0.037889337 1.1987062 0 0 1.2365956 -44.251509 30944.004 35801.925 19832.696 36241.326 2042.3054 2320.5193 1660.0834 + 70 11.272241 -45.411622 0.07431614 0.51778317 0 0 0.59209931 -44.248316 32055.564 39306.193 30181.52 25601.501 1373.4778 -4501.0686 -2570.4767 + 80 14.011502 -46.081444 0.089688317 1.006928 0 0 1.0966163 -44.274812 25661.838 38836.598 12603.734 24205.867 -867.36437 -4211.9639 -2820.6725 + 90 17.659498 -46.247295 0.21744649 0.82687716 0 0 1.0443237 -44.308098 12101.207 19426.995 14142.311 1046.299 -2157.5418 -2141.2454 -2621.456 + +AMEOBA/HIPPO timing info: + Init time: 0.000875735 0.0198199 + Hal time: 0.00136658 3.09288 + Mpole time: 0.0042176 9.5454 + Induce time: 0.0311498 70.4992 + Polar time: 0.00655957 14.8458 + Total time: 0.0441847 + + 100 17.630532 -46.788272 0.61811601 0.9654966 0 0 1.5836126 -44.311254 -4455.3587 3961.5737 -11554.095 -7458.8012 -3120.9771 -1532.1706 -1499.0117 +Loop time of 0.0471312 on 4 procs for 100 steps with 18 atoms + +Performance: 183.318 ns/day, 0.131 hours/ns, 2121.739 timesteps/s +98.9% CPU use with 4 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.044346 | 0.044424 | 0.044557 | 0.0 | 94.26 +Bond | 9.3929e-05 | 0.00010313 | 0.00011252 | 0.0 | 0.22 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.00071684 | 0.00091755 | 0.0010385 | 0.0 | 1.95 +Output | 0.0011333 | 0.0012027 | 0.0013253 | 0.2 | 2.55 +Modify | 4.2618e-05 | 5.1978e-05 | 6.2018e-05 | 0.0 | 0.11 +Other | | 0.0004322 | | | 0.92 + +Nlocal: 4.5 ave 6 max 3 min +Histogram: 1 0 0 1 0 0 1 0 0 1 +Nghost: 13.5 ave 15 max 12 min +Histogram: 1 0 0 1 0 0 1 0 0 1 +Neighs: 38.25 ave 77 max 9 min +Histogram: 2 0 0 0 0 0 1 0 0 1 + +Total # of neighbors = 153 +Ave neighs/atom = 8.5 +Ave special neighs/atom = 2 +Neighbor list builds = 0 +Dangerous builds = 0 +Total wall time: 0:00:00 diff --git a/examples/amoeba/log.water_hexamer.hippo.1 b/examples/amoeba/log.water_hexamer.hippo.1 new file mode 100644 index 0000000000..520fb3e3e0 --- /dev/null +++ b/examples/amoeba/log.water_hexamer.hippo.1 @@ -0,0 +1,153 @@ +LAMMPS (24 Mar 2022) +# water hexamer with AMOEBA or HIPPO + +units real +boundary s s s + +atom_style amoeba +bond_style class2 +angle_style amoeba +dihedral_style none + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes +fix extra2 all property/atom i_polaxe + +# read data file + +read_data data.water_hexamer.hippo fix amtype NULL "Tinker Types" +Reading data file ... + orthogonal box = (-2.517835 -1.523041 -1.734766) to (2.675716 2.01883 2.220847) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 18 atoms + scanning bonds ... + 2 = max bonds/atom + scanning angles ... + 1 = max angles/atom + reading bonds ... + 12 bonds + reading angles ... + 6 angles +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + read_data CPU = 0.007 seconds + +# force field + +pair_style hippo +pair_coeff * * hippo_water.prm hippo_water.key + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0.5 0.5 0.5 + special bond factors coul: 0.5 0.5 0.5 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of 1-5 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] + +dump 1 all custom 10 dump.water_hexamer id type x y z fx fy fz +dump_modify 1 sort id + +# zero step run + +#run 0 + +# dynamics + +fix 1 all nve + +thermo 10 +run 100 +AMOEBA/HIPPO force field settings + repulsion: cut 10 taper 8 rscale 0 0 1 1 + qxfer: cut 10 taper 8 mscale 0 0 0.4 1 + dispersion: cut 10 aewald 0 dspscale 0 0 0.4 1 + multipole: cut 10 aewald 0 mscale 0 0 0.4 1 + polar: cut 10 aewald 0 + pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 0.2 1 1 1 d/u scale 0 1 + precondition: cut 4.5 + generated 0 of 1 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 12 + ghost atom cutoff = 12 + binsize = 6, bins = 1 1 1 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair hippo, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d + bin: standard + AMOEBA/HIPPO group count: 6 +Per MPI rank memory allocation (min/avg/max) = 9.804 | 9.804 | 9.804 Mbytes + Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] + 0 0 -47.362156 1.9820353 1.6634749 0 0 3.6455102 -43.716646 -34513.768 -42206.078 -31383.641 -29951.584 2850.1184 3579.9253 5768.3698 + 10 11.52238 -45.959856 1.53397 0.085100522 0 0 1.6190706 -43.756903 -28644.676 -34867.94 -19324.955 -32842.522 -370.63233 -6452.0859 -4002.3535 + 20 20.237283 -46.772008 0.54762833 1.3835192 0 0 1.9311476 -43.815361 -10546.356 -10116.359 -17063.425 -6393.701 -1166.7608 4243.6327 3493.9596 + 30 20.666374 -45.011106 0.086797459 0.071122604 0 0 0.15792006 -43.805943 13150.762 15882.022 10964.553 10630.278 -6754.7642 -432.29165 -3783.115 + 40 10.639014 -45.430939 0.18926921 0.96410995 0 0 1.1533792 -43.738441 33402.664 41252.58 19726.586 38211.875 -6166.03 6081.5692 1815.7739 + 50 10.992432 -44.741108 0.19575431 0.25851128 0 0 0.45426559 -43.729815 37696.923 41572.466 33299.43 37168.141 -3254.5134 2.9639226 -1017.3669 + 60 19.748633 -45.461264 0.035287281 0.63217389 0 0 0.66746117 -43.793065 26212.839 28825.788 16048.096 31876.925 3504.5461 135.3505 420.28566 + 70 26.129957 -46.022729 0.30434543 0.56770169 0 0 0.87204711 -43.826579 3919.9866 -2755.6905 11500.428 517.54333 5626.9543 -2238.5786 86.305984 + 80 17.768494 -46.309777 1.1680612 0.45551823 0 0 1.6235794 -43.785801 -18335.898 -22168.789 -14488.992 -20048.346 7343.173 -2646.2196 -2525.6625 + 90 8.3822494 -47.063502 2.0182644 0.88875358 0 0 2.9070179 -43.731724 -33693.203 -43487.996 -15178.35 -43214.494 2412.6411 1993.0113 1780.7512 + +AMEOBA/HIPPO timing info: + Init time: 0.000305988 0.00772963 + Repls time: 0.00615705 15.5535 + Disp time: 0.00270421 6.83116 + Mpole time: 0.00727575 18.3794 + Induce time: 0.0137304 34.6848 + Polar time: 0.00789202 19.9362 + Qxfer time: 0.00151645 3.83073 + Total time: 0.0395864 + + 100 8.6486333 -46.517402 1.9551958 0.38696887 0 0 2.3421647 -43.736979 -34734.97 -34372.659 -28372.146 -42286.799 226.18821 40.353457 -755.93912 +Loop time of 0.0411107 on 1 procs for 100 steps with 18 atoms + +Performance: 210.164 ns/day, 0.114 hours/ns, 2432.456 timesteps/s +94.5% CPU use with 1 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.039681 | 0.039681 | 0.039681 | 0.0 | 96.52 +Bond | 0.00018196 | 0.00018196 | 0.00018196 | 0.0 | 0.44 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 1.8274e-05 | 1.8274e-05 | 1.8274e-05 | 0.0 | 0.04 +Output | 0.0010806 | 0.0010806 | 0.0010806 | 0.0 | 2.63 +Modify | 7.5438e-05 | 7.5438e-05 | 7.5438e-05 | 0.0 | 0.18 +Other | | 7.382e-05 | | | 0.18 + +Nlocal: 18 ave 18 max 18 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 0 ave 0 max 0 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 153 ave 153 max 153 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 153 +Ave neighs/atom = 8.5 +Ave special neighs/atom = 2 +Neighbor list builds = 0 +Dangerous builds = 0 +Total wall time: 0:00:00 diff --git a/examples/amoeba/log.water_hexamer.hippo.4 b/examples/amoeba/log.water_hexamer.hippo.4 new file mode 100644 index 0000000000..4800cbd6d5 --- /dev/null +++ b/examples/amoeba/log.water_hexamer.hippo.4 @@ -0,0 +1,154 @@ +LAMMPS (24 Mar 2022) +# water hexamer with AMOEBA or HIPPO + +units real +boundary s s s + +atom_style amoeba +bond_style class2 +angle_style amoeba +dihedral_style none + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes +fix extra2 all property/atom i_polaxe + +# read data file + +read_data data.water_hexamer.hippo fix amtype NULL "Tinker Types" +Reading data file ... + orthogonal box = (-2.517835 -1.523041 -1.734766) to (2.675716 2.01883 2.220847) + 2 by 1 by 2 MPI processor grid + reading atoms ... + 18 atoms + scanning bonds ... + 2 = max bonds/atom + scanning angles ... + 1 = max angles/atom + reading bonds ... + 12 bonds + reading angles ... + 6 angles +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + read_data CPU = 0.007 seconds + +# force field + +pair_style hippo +pair_coeff * * hippo_water.prm hippo_water.key + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0.5 0.5 0.5 + special bond factors coul: 0.5 0.5 0.5 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of 1-5 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] + +dump 1 all custom 10 dump.water_hexamer id type x y z fx fy fz +dump_modify 1 sort id + +# zero step run + +#run 0 + +# dynamics + +fix 1 all nve + +thermo 10 +run 100 +AMOEBA/HIPPO force field settings + repulsion: cut 10 taper 8 rscale 0 0 1 1 + qxfer: cut 10 taper 8 mscale 0 0 0.4 1 + dispersion: cut 10 aewald 0 dspscale 0 0 0.4 1 + multipole: cut 10 aewald 0 mscale 0 0 0.4 1 + polar: cut 10 aewald 0 + pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 0.2 1 1 1 d/u scale 0 1 + precondition: cut 4.5 + generated 0 of 1 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 12 + ghost atom cutoff = 12 + binsize = 6, bins = 1 1 1 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair hippo, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d + bin: standard +WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (../domain.cpp:974) + AMOEBA/HIPPO group count: 6 +Per MPI rank memory allocation (min/avg/max) = 9.833 | 9.833 | 9.833 Mbytes + Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] + 0 0 -47.362156 1.9820353 1.6634749 0 0 3.6455102 -43.716646 -34513.768 -42206.078 -31383.641 -29951.584 2850.1184 3579.9253 5768.3698 + 10 11.52238 -45.959856 1.53397 0.085100522 0 0 1.6190706 -43.756903 -28644.676 -34867.94 -19324.955 -32842.522 -370.63233 -6452.0859 -4002.3535 + 20 20.237283 -46.772008 0.54762833 1.3835192 0 0 1.9311476 -43.815361 -10546.356 -10116.359 -17063.425 -6393.701 -1166.7608 4243.6327 3493.9596 + 30 20.666374 -45.011106 0.086797459 0.071122604 0 0 0.15792006 -43.805943 13150.762 15882.022 10964.553 10630.278 -6754.7642 -432.29165 -3783.115 + 40 10.639014 -45.430939 0.18926921 0.96410995 0 0 1.1533792 -43.738441 33402.664 41252.58 19726.586 38211.875 -6166.03 6081.5692 1815.7739 + 50 10.992432 -44.741108 0.19575431 0.25851128 0 0 0.45426559 -43.729815 37696.923 41572.466 33299.43 37168.141 -3254.5134 2.9639226 -1017.3669 + 60 19.748633 -45.461264 0.035287281 0.63217389 0 0 0.66746117 -43.793065 26212.839 28825.788 16048.096 31876.925 3504.5461 135.3505 420.28566 + 70 26.129957 -46.022729 0.30434543 0.56770169 0 0 0.87204711 -43.826579 3919.9866 -2755.6905 11500.428 517.54333 5626.9543 -2238.5786 86.305984 + 80 17.768494 -46.309777 1.1680612 0.45551823 0 0 1.6235794 -43.785801 -18335.898 -22168.789 -14488.992 -20048.346 7343.173 -2646.2196 -2525.6625 + 90 8.3822494 -47.063502 2.0182644 0.88875358 0 0 2.9070179 -43.731724 -33693.203 -43487.996 -15178.35 -43214.494 2412.6411 1993.0113 1780.7512 + +AMEOBA/HIPPO timing info: + Init time: 0.000674024 0.0214167 + Repls time: 0.00313927 9.97487 + Disp time: 0.000678053 2.15448 + Mpole time: 0.00411311 13.0692 + Induce time: 0.018633 59.2054 + Polar time: 0.00385369 12.2449 + Qxfer time: 0.000376264 1.19556 + Total time: 0.0314718 + + 100 8.6486333 -46.517402 1.9551958 0.38696887 0 0 2.3421647 -43.736979 -34734.97 -34372.659 -28372.146 -42286.799 226.18821 40.353457 -755.93912 +Loop time of 0.0345189 on 4 procs for 100 steps with 18 atoms + +Performance: 250.298 ns/day, 0.096 hours/ns, 2896.962 timesteps/s +97.4% CPU use with 4 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.031394 | 0.031738 | 0.032246 | 0.2 | 91.94 +Bond | 5.8552e-05 | 7.4876e-05 | 9.4475e-05 | 0.0 | 0.22 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.00068606 | 0.0012736 | 0.0016838 | 1.2 | 3.69 +Output | 0.00098398 | 0.0010248 | 0.0011389 | 0.2 | 2.97 +Modify | 3.693e-05 | 4.5649e-05 | 5.4845e-05 | 0.0 | 0.13 +Other | | 0.0003625 | | | 1.05 + +Nlocal: 4.5 ave 6 max 3 min +Histogram: 1 0 0 1 0 0 1 0 0 1 +Nghost: 13.5 ave 15 max 12 min +Histogram: 1 0 0 1 0 0 1 0 0 1 +Neighs: 38.25 ave 77 max 9 min +Histogram: 2 0 0 0 0 0 1 0 0 1 + +Total # of neighbors = 153 +Ave neighs/atom = 8.5 +Ave special neighs/atom = 2 +Neighbor list builds = 0 +Dangerous builds = 0 +Total wall time: 0:00:00 From e07b46c77158dffa400ec5d1b9c2e556c365a667 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Tue, 17 May 2022 14:40:09 -0600 Subject: [PATCH 162/585] refactoring edits --- examples/amoeba/Compare.sh | 56 ++++----- src/AMOEBA/amoeba_induce.cpp | 215 +---------------------------------- src/AMOEBA/amoeba_polar.cpp | 17 --- src/AMOEBA/amoeba_utils.cpp | 56 +++++---- src/AMOEBA/pair_amoeba.cpp | 151 ++++++------------------ src/AMOEBA/pair_amoeba.h | 2 +- 6 files changed, 89 insertions(+), 408 deletions(-) diff --git a/examples/amoeba/Compare.sh b/examples/amoeba/Compare.sh index 9c57bb8d92..8eaebcee30 100644 --- a/examples/amoeba/Compare.sh +++ b/examples/amoeba/Compare.sh @@ -2,51 +2,51 @@ # dimer -kdiff log.water_dimer.amoeba.1 log.water_dimer.amoeba.1.test -kdiff dump.water_dimer.amoeba.1 dump.water_dimer.amoeba.1.test +kdiff.py log.water_dimer.amoeba.1 log.water_dimer.amoeba.1.test +kdiff.py dump.water_dimer.amoeba.1 dump.water_dimer.amoeba.1.test -kdiff log.water_dimer.amoeba.4 log.water_dimer.amoeba.4.test -kdiff dump.water_dimer.amoeba.4 dump.water_dimer.amoeba.4.test +kdiff.py log.water_dimer.amoeba.4 log.water_dimer.amoeba.4.test +kdiff.py dump.water_dimer.amoeba.4 dump.water_dimer.amoeba.4.test -kdiff log.water_dimer.hippo.1 log.water_dimer.hippo.1.test -kdiff dump.water_dimer.hippo.1 dump.water_dimer.hippo.1.test +kdiff.py log.water_dimer.hippo.1 log.water_dimer.hippo.1.test +kdiff.py dump.water_dimer.hippo.1 dump.water_dimer.hippo.1.test -kdiff log.water_dimer.hippo.4 log.water_dimer.hippo.4.test -kdiff dump.water_dimer.hippo.4 dump.water_dimer.hippo.4.test +kdiff.py log.water_dimer.hippo.4 log.water_dimer.hippo.4.test +kdiff.py dump.water_dimer.hippo.4 dump.water_dimer.hippo.4.test # hexamer -kdiff log.water_hexamer.amoeba.1 log.water_hexamer.amoeba.1.test -kdiff dump.water_hexamer.amoeba.1 dump.water_hexamer.amoeba.1.test +kdiff.py log.water_hexamer.amoeba.1 log.water_hexamer.amoeba.1.test +kdiff.py dump.water_hexamer.amoeba.1 dump.water_hexamer.amoeba.1.test -kdiff log.water_hexamer.amoeba.4 log.water_hexamer.amoeba.4.test -kdiff dump.water_hexamer.amoeba.4 dump.water_hexamer.amoeba.4.test +kdiff.py log.water_hexamer.amoeba.4 log.water_hexamer.amoeba.4.test +kdiff.py dump.water_hexamer.amoeba.4 dump.water_hexamer.amoeba.4.test -kdiff log.water_hexamer.hippo.1 log.water_hexamer.hippo.1.test -kdiff dump.water_hexamer.hippo.1 dump.water_hexamer.hippo.1.test +kdiff.py log.water_hexamer.hippo.1 log.water_hexamer.hippo.1.test +kdiff.py dump.water_hexamer.hippo.1 dump.water_hexamer.hippo.1.test -kdiff log.water_hexamer.hippo.4 log.water_hexamer.hippo.4.test -kdiff dump.water_hexamer.hippo.4 dump.water_dimer.hippo.4.test +kdiff.py log.water_hexamer.hippo.4 log.water_hexamer.hippo.4.test +kdiff.py dump.water_hexamer.hippo.4 dump.water_hexamer.hippo.4.test # water box -kdiff log.water_box.amoeba.1 log.water_box.amoeba.1.test -kdiff dump.water_box.amoeba.1 dump.water_box.amoeba.1.test +kdiff.py log.water_box.amoeba.1 log.water_box.amoeba.1.test +kdiff.py dump.water_box.amoeba.1 dump.water_box.amoeba.1.test -kdiff log.water_box.amoeba.32 log.water_box.amoeba.32.test -kdiff dump.water_box.amoeba.32 dump.water_box.amoeba.32.test +kdiff.py log.water_box.amoeba.32 log.water_box.amoeba.32.test +kdiff.py dump.water_box.amoeba.32 dump.water_box.amoeba.32.test -kdiff log.water_box.hippo.1 log.water_box.hippo.1.test -kdiff dump.water_box.hippo.1 dump.water_box.hippo.1.test +kdiff.py log.water_box.hippo.1 log.water_box.hippo.1.test +kdiff.py dump.water_box.hippo.1 dump.water_box.hippo.1.test -kdiff log.water_box.hippo.32 log.water_box.hippo.32.test -kdiff dump.water_box.hippo.32 dump.water_box.hippo.32.test +kdiff.py log.water_box.hippo.32 log.water_box.hippo.32.test +kdiff.py dump.water_box.hippo.32 dump.water_box.hippo.32.test # ubiquitin -kdiff log.ubi.1 log.ubi.1.test -kdiff dump.ubi.1 dump.ubi.1.test +kdiff.py log.ubi.1 log.ubi.1.test +kdiff.py dump.ubi.1 dump.ubi.1.test -kdiff log.ubi.32 log.ubi.32.test -kdiff dump.ubi.32 dump.ubi.32.test +kdiff.py log.ubi.32 log.ubi.32.test +kdiff.py dump.ubi.32 dump.ubi.32.test diff --git a/src/AMOEBA/amoeba_induce.cpp b/src/AMOEBA/amoeba_induce.cpp index cbd0a2c480..c23e6c4516 100644 --- a/src/AMOEBA/amoeba_induce.cpp +++ b/src/AMOEBA/amoeba_induce.cpp @@ -40,8 +40,6 @@ enum{GORDON1,GORDON2}; #define DEBYE 4.80321 // conversion factor from q-Angs (real units) to Debye -#define UIND_DEBUG 0 - /* ---------------------------------------------------------------------- induce = induced dipole moments via pre-conditioned CG solver adapted from Tinker induce0a() routine @@ -113,17 +111,6 @@ void PairAmoeba::induce() crstyle = FIELD; comm->reverse_comm(this); - // DEBUG statements - - /* - for (i = 0; i < nlocal; i++) - if (atom->tag[i] == 1) - printf("AAA FIELD atom %d: field %g %g %g: fieldp %g %g %g\n", - atom->tag[i], - field[i][0],field[i][1],field[i][2], - fieldp[i][0],fieldp[i][1],fieldp[i][2]); - */ - // set induced dipoles to polarizability times direct field for (i = 0; i < nlocal; i++) { @@ -138,17 +125,6 @@ void PairAmoeba::induce() } } - // DEBUG statements - - /* - for (i = 0; i < nlocal; i++) - if (atom->tag[i] == 1) - printf("AAA UDIR atom %d: udir %g %g %g: udirp %g %g %g\n", - atom->tag[i], - DEBYE*udir[i][0],DEBYE*udir[i][1],DEBYE*udir[i][2], - DEBYE*udirp[i][0],DEBYE*udirp[i][1],DEBYE*udirp[i][2]); - */ - // get induced dipoles via the OPT extrapolation method // NOTE: any way to rewrite these loops to avoid allocating // uopt,uoptp with a optorder+1 dimension, just optorder ?? @@ -258,20 +234,6 @@ void PairAmoeba::induce() crstyle = FIELD; comm->reverse_comm(this); - // DEBUG statements - - /* - for (i = 0; i < nlocal; i++) - if (atom->tag[i] == 1) - printf("UFIELD atom %d: uind %g %g %g uinp %g %g %g " - "field %g %g %g: fieldp %g %g %g\n", - atom->tag[i], - uind[i][0],uind[i][1],uind[i][2], - uinp[i][0],uinp[i][1],uinp[i][2], - field[i][0],field[i][1],field[i][2], - fieldp[i][0],fieldp[i][1],fieldp[i][2]); - */ - // set initial conjugate gradient residual and conjugate vector for (i = 0; i < nlocal; i++) { @@ -307,20 +269,6 @@ void PairAmoeba::induce() } } - // DEBUG statements - - /* - for (i = 0; i < nlocal; i++) - if (atom->tag[i] == 1) - printf("CONJ atom %d: rsd %g %g %g rsdp %g %g %g " - "conj %g %g %g: conjp %g %g %g\n", - atom->tag[i], - rsd[i][0],rsd[i][1],rsd[i][2], - rsdp[i][0],rsdp[i][1],rsdp[i][2], - conj[i][0],conj[i][1],conj[i][2], - conjp[i][0],conjp[i][1],conjp[i][2]); - */ - // conjugate gradient iteration of the mutual induced dipoles while (!done) { @@ -345,19 +293,6 @@ void PairAmoeba::induce() crstyle = FIELD; comm->reverse_comm(this); - // DEBUG statements - - /* - for (i = 0; i < nlocal; i++) - if (atom->tag[i] == 1) - printf("POST-COMM FIELD atom %d: field %g %g %g: fieldp %g %g %g\n", - atom->tag[i], - uind[i][0],uind[i][1],uind[i][2], - uinp[i][0],uinp[i][1],uinp[i][2], - field[i][0],field[i][1],field[i][2], - fieldp[i][0],fieldp[i][1],fieldp[i][2]); - */ - for (i = 0; i < nlocal; i++) { for (j = 0; j < 3; j++) { uind[i][j] = vec[i][j]; @@ -405,17 +340,6 @@ void PairAmoeba::induce() } } - // DEBUG statements - - /* - for (i = 0; i < nlocal; i++) - if (atom->tag[i] == 1) - printf("POST-MPI UIND atom %d: uind %g %g %g: uinp %g %g %g\n", - atom->tag[i], - uind[i][0],uind[i][1],uind[i][2], - uinp[i][0],uinp[i][1],uinp[i][2]); - */ - if (pcgprec) { cfstyle = RSD; comm->forward_comm(this); @@ -424,20 +348,6 @@ void PairAmoeba::induce() comm->reverse_comm(this); } - // DEBUG statements - - /* - for (i = 0; i < nlocal; i++) - if (atom->tag[i] == 1) - printf("POST-PRECOND atom %d: rsd %g %g %g: rsdp %g %g %g " - "zrsd %g %g %g: zrsdp %g %g %g\n", - atom->tag[i], - rsd[i][0],rsd[i][1],rsd[i][2], - rsdp[i][0],rsdp[i][1],rsdp[i][2], - zrsd[i][0],zrsd[i][1],zrsd[i][2], - zrsdp[i][0],zrsdp[i][1],zrsdp[i][2]); - */ - b = 0.0; bp = 0.0; @@ -483,32 +393,12 @@ void PairAmoeba::induce() eps = MAX(epsd,epsp); eps = DEBYE * sqrt(eps/atom->natoms); - /* - if (debug) { - if (comm->me == 0 && screen) { - fprintf(screen,"SCF induced dipole moments: " - "iter %d, RMS residual (Debye) %g\n",iter,eps); - } - } - */ - if (eps < poleps) done = true; if (eps > epsold) done = true; if (iter >= politer) done = true; // apply a "peek" iteration to the mutual induced dipoles - // DEBUG statements - - /* - printf("DONE %d\n",done); - for (i = 0; i < nlocal; i++) - printf("PRE-DONE UIND atom %d: uind %g %g %g: uinp %g %g %g\n", - atom->tag[i], - uind[i][0],uind[i][1],uind[i][2], - uinp[i][0],uinp[i][1],uinp[i][2]); - */ - if (done) { for (i = 0; i < nlocal; i++) { term = pcgpeek * poli[i]; @@ -518,17 +408,6 @@ void PairAmoeba::induce() } } } - - // DEBUG statements - - /* - for (i = 0; i < nlocal; i++) - if (atom->tag[i] == 1) - printf("POST-DONE UIND atom %d: uind %g %g %g: uinp %g %g %g\n", - atom->tag[i], - DEBYE*uind[i][0],DEBYE*uind[i][1],DEBYE*uind[i][2], - DEBYE*uinp[i][0],DEBYE*uinp[i][1],DEBYE*uinp[i][2]); - */ } // terminate the calculation if dipoles failed to converge @@ -539,11 +418,6 @@ void PairAmoeba::induce() error->warning(FLERR,"AMOEBA induced dipoles did not converge"); } - // DEBUG output to dump file - - if (UIND_DEBUG) - dump6(fp_uind,"id uindx uindy uindz uinpx uinpy uinpz",DEBYE,uind,uinp); - // deallocation of arrays memory->destroy(poli); @@ -731,14 +605,6 @@ void PairAmoeba::ufield0c(double **field, double **fieldp) field[i][j] += term*uind[i][j]; fieldp[i][j] += term*uinp[i][j]; } - - /* - // DEBUG - - printf("UMUTUAL2B SELF i %d term %g aewald %g uind %g %g %g field %g %g %g\n", - atom->tag[i],term,aewald, - uind[i][0],uind[i][1],uind[i][2],field[i][0],field[i][1],field[i][2]); - */ } } @@ -939,18 +805,6 @@ void PairAmoeba::uscale0b(int mode, double **rsd, double **rsdp, pclist[3] = rr5*yr*yr - rr3; pclist[4] = rr5*yr*zr; pclist[5] = rr5*zr*zr - rr3; - - // DEBUG - - /* - printf("PCLIST: ij %d %d: pc1-6 %g %g %g %g %g %g\n", - atom->tag[i],atom->tag[j], - pclist[0],pclist[1],pclist[2],pclist[3],pclist[4],pclist[5]); - printf(" AMOEBA: scale35 %g %g pdamp %g thole %g " - "pgamma %g facUscale %g damp %g\n", - scale3,scale5,pdamp[jtype],thole[jtype],pgamma,factor_uscale,damp); - */ - pclist += 6; } } @@ -1054,11 +908,6 @@ void PairAmoeba::umutual1(double **field, double **fieldp) } } - /* - printf("fuind %g %g %g \n",fuind[0][0],fuind[0][1],fuind[0][2]); - printf("fuinp %g %g %g \n",fuinp[0][0],fuinp[0][1],fuinp[0][2]); - */ - // gridpre = my portion of 4d grid in brick decomp w/ ghost values double ****gridpre = (double ****) ic_kspace->zero(); @@ -1106,16 +955,6 @@ void PairAmoeba::umutual1(double **field, double **fieldp) fphi_uind(gridpost,fdip_phi1,fdip_phi2,fdip_sum_phi); - // printf ("fdip_phi1_uind %g %g %g %g %g %g %g %g %g %g\n", - // fdip_phi1[0][0], - // fdip_phi1[0][1],fdip_phi1[0][2],fdip_phi1[0][3],fdip_phi1[0][4],fdip_phi1[0][5], - // fdip_phi1[0][6],fdip_phi1[0][7],fdip_phi1[0][8],fdip_phi1[0][9],fdip_phi1[0][10]); - - // printf ("fdip_phi2_uind %g %g %g %g %g %g %g %g %g %g\n", - // fdip_phi2[0][0], - // fdip_phi2[0][1],fdip_phi2[0][2],fdip_phi2[0][3],fdip_phi2[0][4],fdip_phi2[0][5], - // fdip_phi2[0][6],fdip_phi2[0][7],fdip_phi2[0][8],fdip_phi2[0][9],fdip_phi2[0][10]); - // store fractional reciprocal potentials for OPT method if (poltyp == OPT) { @@ -1217,21 +1056,6 @@ void PairAmoeba::umutual2b(double **field, double **fieldp) fkp[1] = tdipdip[1]*uinpi[0] + tdipdip[3]*uinpi[1] + tdipdip[4]*uinpi[2]; fkp[2] = tdipdip[2]*uinpi[0] + tdipdip[4]*uinpi[1] + tdipdip[5]*uinpi[2]; - // DEBUG - - /* - if (atom->tag[i] == 1 || atom->tag[j] == 1) { - printf ("TDIPDIP ij %d %d: tdd %g %g %g %g %g %g\n", - atom->tag[i],atom->tag[j], - tdipdip[0],tdipdip[1],tdipdip[2], - tdipdip[3],tdipdip[4],tdipdip[5]); - printf ("FIDFKD ij %d %d: fid %g %g %g fkd %g %g %g\n", - atom->tag[i],atom->tag[j], - fid[0],fid[1],fid[2], - fkd[0],fkd[1],fkd[2]); - } - */ - tdipdip += 6; // increment the field at each site due to this interaction @@ -1375,11 +1199,6 @@ void PairAmoeba::udirect1(double **field) fphi_mpole(gridpost,fphi); - // printf ("fphi %g %g %g %g %g %g %g %g %g %g %g %g\n", - // fphi[1][1],fphi[1][2],fphi[1][3],fphi[1][4],fphi[1][5], - // fphi[1][6],fphi[1][7],fphi[1][8],fphi[1][9],fphi[1][10], - // fphi[1][11],fphi[1][12]); - // convert the field from fractional to Cartesian fphi_to_cphi(fphi,cphi); @@ -1450,7 +1269,7 @@ void PairAmoeba::udirect2b(double **field, double **fieldp) numneigh = list->numneigh; firstneigh = list->firstneigh; - // NOTE: doesn't this have a problem if aewald is tiny ?? + // NOTE: does this have a problem if aewald is tiny ?? aesq2 = 2.0 * aewald * aewald; aesq2n = 0.0; @@ -1496,18 +1315,6 @@ void PairAmoeba::udirect2b(double **field, double **fieldp) vali = pval[i]; } - // DEBUG - - /* - if (atom->tag[i] == 4) { - printf("Atom 4 is in group %d\n",igroup); - printf("Atoms in same group:"); - for (int ig = 0; ig < atom->nlocal; ig++) - if (amgroup[ig] == igroup) printf(" %d",atom->tag[ig]); - printf("\n"); - } - */ - // evaluate all sites within the cutoff distance for (jj = 0; jj < jnum; jj++) { @@ -1546,16 +1353,6 @@ void PairAmoeba::udirect2b(double **field, double **fieldp) } } - // DEBUG - - /* - if (atom->tag[i] == 4 || atom->tag[j] == 4) { - printf("PAIR ij %d %d ij group %d %d wpdu scale %g %g %g %g\n", - atom->tag[i],atom->tag[j],igroup,jgroup, - factor_wscale,factor_pscale,factor_dscale,factor_uscale); - } - */ - r = sqrt(r2); rr1 = 1.0 / r; rr2 = rr1 * rr1; @@ -1749,16 +1546,6 @@ void PairAmoeba::udirect2b(double **field, double **fieldp) rr3ik = bn[1] - (1.0-scalek*dmpik[2])*rr3; rr5ik = bn[2] - (1.0-scalek*dmpik[4])*rr5; - // DEBUG - - /* - if (atom->tag[i] == 1 || atom->tag[j] == 1) - printf ("DAMPMUT ij %d %d: bn12 %g %g dmpik-01234 %g %g %g %g %g\n", - atom->tag[i],atom->tag[j], - bn[1],bn[2], - dmpik[0],dmpik[1],dmpik[2],dmpik[3],dmpik[4]); - */ - neighptr[n++] = j; tdipdip[ndip++] = -rr3ik + rr5ik*xr*xr; tdipdip[ndip++] = rr5ik*xr*yr; diff --git a/src/AMOEBA/amoeba_polar.cpp b/src/AMOEBA/amoeba_polar.cpp index d067fd5dc0..302121ebc6 100644 --- a/src/AMOEBA/amoeba_polar.cpp +++ b/src/AMOEBA/amoeba_polar.cpp @@ -23,10 +23,6 @@ #include "math_const.h" #include "memory.h" -// DEBUG - -#include "error.h" - using namespace LAMMPS_NS; using namespace MathConst; @@ -1436,8 +1432,6 @@ void PairAmoeba::polar_kspace() } } - //PRINT fuind - // gridpre2 = my portion of 4d grid in brick decomp w/ ghost values double ****gridpre2 = (double ****) pc_kspace->zero(); @@ -1880,17 +1874,6 @@ void PairAmoeba::polar_kspace() double ***gridpre = (double ***) p_kspace->zero(); - // DEBUG - - double psum = 0.0; - for (k = p_kspace->nzlo_out; k <= p_kspace->nzhi_out; k++) { - for (j = p_kspace->nylo_out; j <= p_kspace->nyhi_out; j++) { - for (i = p_kspace->nxlo_out; i <= p_kspace->nxhi_out; i++) { - psum += gridpre[k][j][i]; - } - } - } - // map atoms to grid grid_mpole(fmp,gridpre); diff --git a/src/AMOEBA/amoeba_utils.cpp b/src/AMOEBA/amoeba_utils.cpp index c52b8bbcac..059587a093 100644 --- a/src/AMOEBA/amoeba_utils.cpp +++ b/src/AMOEBA/amoeba_utils.cpp @@ -30,7 +30,7 @@ enum{NOFRAME,ZONLY,ZTHENX,BISECTOR,ZBISECT,THREEFOLD}; /* ---------------------------------------------------------------------- kmpole performs one-time assignment of - xaxis,yaxis,zaxis multipole neighbors to each owned atom + xyzaxis multipole neighbors to each owned atom any of the values can be 0 if not used yaxis can later be negative due to chkpole() also sets polaxe and pole[13] multipole for each owned atom @@ -52,9 +52,7 @@ void PairAmoeba::kmpole() amtype = atom->ivector[index_amtype]; int *polaxe = atom->ivector[index_polaxe]; - double *xaxis = atom->dvector[index_xaxis]; - double *yaxis = atom->dvector[index_yaxis]; - double *zaxis = atom->dvector[index_zaxis]; + double **xyzaxis = atom->darray[index_xyzaxis]; double **pole = fixpole->astore; int **nspecial = atom->nspecial; @@ -125,9 +123,9 @@ void PairAmoeba::kmpole() if (ktype == xtype) { if (ytype == 0 && !flag) { flag = 1; - zaxis[i] = ubuf(jneigh).d; - xaxis[i] = ubuf(kneigh).d; - yaxis[i] = 0.0; + xyzaxis[i][2] = ubuf(jneigh).d; + xyzaxis[i][0] = ubuf(kneigh).d; + xyzaxis[i][1] = 0.0; polaxe[i] = mpaxis[itype][iframe]; for (j = 0; j < 13; j++) pole[i][j] = fpole[itype][iframe][j]; @@ -141,9 +139,9 @@ void PairAmoeba::kmpole() mtype = amtype[m]; if (mtype == ytype && !flag) { flag = 1; - zaxis[i] = ubuf(jneigh).d; - xaxis[i] = ubuf(kneigh).d; - yaxis[i] = ubuf(mneigh).d; + xyzaxis[i][2] = ubuf(jneigh).d; + xyzaxis[i][0] = ubuf(kneigh).d; + xyzaxis[i][1] = ubuf(mneigh).d; polaxe[i] = mpaxis[itype][iframe]; for (j = 0; j < 13; j++) pole[i][j] = fpole[itype][iframe][j]; @@ -183,9 +181,9 @@ void PairAmoeba::kmpole() if (ktype == xtype) { if (ytype == 0 && !flag) { flag = 1; - zaxis[i] = ubuf(jneigh).d; - xaxis[i] = ubuf(kneigh).d; - yaxis[i] = 0.0; + xyzaxis[i][2] = ubuf(jneigh).d; + xyzaxis[i][0] = ubuf(kneigh).d; + xyzaxis[i][1] = 0.0; polaxe[i] = mpaxis[itype][iframe]; for (j = 0; j < 13; j++) pole[i][j] = fpole[itype][iframe][j]; @@ -203,9 +201,9 @@ void PairAmoeba::kmpole() if (!path) continue; if (mtype == ytype && !flag) { flag = 1; - zaxis[i] = ubuf(jneigh).d; - xaxis[i] = ubuf(kneigh).d; - yaxis[i] = ubuf(mneigh).d; + xyzaxis[i][2] = ubuf(jneigh).d; + xyzaxis[i][0] = ubuf(kneigh).d; + xyzaxis[i][1] = ubuf(mneigh).d; polaxe[i] = mpaxis[itype][iframe]; for (j = 0; j < 13; j++) pole[i][j] = fpole[itype][iframe][j]; @@ -234,8 +232,8 @@ void PairAmoeba::kmpole() if (jtype == ztype) { if (xtype == 0 && !flag) { flag = 1; - zaxis[i] = ubuf(jneigh).d; - xaxis[i] = yaxis[i] = 0.0; + xyzaxis[i][2] = ubuf(jneigh).d; + xyzaxis[i][0] = xyzaxis[i][1] = 0.0; polaxe[i] = mpaxis[itype][iframe]; for (j = 0; j < 13; j++) pole[i][j] = fpole[itype][iframe][j]; @@ -254,7 +252,7 @@ void PairAmoeba::kmpole() ztype = zpole[itype][iframe]; if (ztype == 0 && !flag) { flag = 1; - zaxis[i] = xaxis[i] = yaxis[i] = 0.0; + xyzaxis[i][2] = xyzaxis[i][0] = xyzaxis[i][2] = 0.0; polaxe[i] = mpaxis[itype][iframe]; for (j = 0; j < 13; j++) pole[i][j] = fpole[itype][iframe][j]; @@ -297,8 +295,8 @@ void PairAmoeba::chkpole(int i) double **pole = fixpole->astore; int *polaxe = atom->ivector[index_polaxe]; - double *yaxis = atom->dvector[index_yaxis]; - tagint yaxisID = (tagint) ubuf(yaxis[i]).i; + double **xyzaxis = atom->darray[index_xyzaxis]; + tagint yaxisID = (tagint) ubuf(xyzaxis[i][1]).i; // test for chirality inversion // if not, return @@ -334,7 +332,7 @@ void PairAmoeba::chkpole(int i) // flip sign in permanent yaxis, not yaxis2local if ((yaxisID < 0 && vol > 0.0) || (yaxisID > 0 && vol < 0.0)) { - yaxis[i] = -ubuf(yaxisID).d; + xyzaxis[i][1] = -ubuf(yaxisID).d; pole[i][2] = -pole[i][2]; pole[i][5] = -pole[i][5]; pole[i][7] = -pole[i][7]; @@ -716,21 +714,19 @@ void PairAmoeba::find_multipole_neighbors() tagint xaxisID,yaxisID,zaxisID; // grab current pts for xaxis,yaxis,zaxis - // xyz axis[i] = atom IDs that atom I uses for its multipole orientation + // xyzaxis[i] = atom IDs that atom I uses for its multipole orientation // can be zero if not used, in which case set local index to self // yaxis can be negative, in which case use absolute value - double *xaxis = atom->dvector[index_xaxis]; - double *yaxis = atom->dvector[index_yaxis]; - double *zaxis = atom->dvector[index_zaxis]; + double **xyzaxis = atom->darray[index_xyzaxis]; int nlocal = atom->nlocal; int nmissing = 0; for (int i = 0; i < nlocal; i++) { - xaxisID = (tagint) ubuf(xaxis[i]).i; - yaxisID = (tagint) ubuf(yaxis[i]).i; - zaxisID = (tagint) ubuf(zaxis[i]).i; + xaxisID = (tagint) ubuf(xyzaxis[i][0]).i; + yaxisID = (tagint) ubuf(xyzaxis[i][1]).i; + zaxisID = (tagint) ubuf(xyzaxis[i][2]).i; if (xaxisID) { index = atom->map(xaxisID); @@ -742,7 +738,7 @@ void PairAmoeba::find_multipole_neighbors() } else xaxis2local[i] = i; if (yaxisID) { - if (yaxis[i] < 0) yaxisID = -yaxisID; + if (xyzaxis[i][1] < 0) yaxisID = -yaxisID; index = atom->map(yaxisID); if (index == -1) nmissing++; else { diff --git a/src/AMOEBA/pair_amoeba.cpp b/src/AMOEBA/pair_amoeba.cpp index 0c9f6f8b6e..8bae12955a 100644 --- a/src/AMOEBA/pair_amoeba.cpp +++ b/src/AMOEBA/pair_amoeba.cpp @@ -316,7 +316,7 @@ void PairAmoeba::compute(int eflag, int vflag) // if reneighboring step: // augment neighbor list to include 1-5 neighbor flags - // re-create xyz axis2local and red2local + // re-create red2local and xyz axis2local // re-create induce neighbor list if (neighbor->ago == 0) { @@ -710,15 +710,9 @@ void PairAmoeba::init_style() index_redID = atom->find_custom("redID",flag,cols); if (index_redID < 0 || !flag || cols) error->all(FLERR,"Pair amoeba redID is not defined"); - index_xaxis = atom->find_custom("xaxis",flag,cols); - if (index_xaxis < 0 || !flag || cols) - error->all(FLERR,"Pair amoeba xaxis is not defined"); - index_yaxis = atom->find_custom("yaxis",flag,cols); - if (index_yaxis < 0 || !flag || cols) - error->all(FLERR,"Pair amoeba yaxis is not defined"); - index_zaxis = atom->find_custom("zaxis",flag,cols); - if (index_zaxis < 0 || !flag || cols) - error->all(FLERR,"Pair amoeba zaxis is not defined"); + index_xyzaxis = atom->find_custom("xyzaxis",flag,cols); + if (index_xyzaxis < 0 || !flag || cols == 0) + error->all(FLERR,"Pair amoeba xyzaxis is not defined"); index_polaxe = atom->find_custom("polaxe",flag,cols); if (index_polaxe < 0 || flag || cols) @@ -1995,11 +1989,8 @@ void PairAmoeba::mix() double TWOSIX = pow(2.0,1.0/6.0); for (i = 1; i <= n_amclass; i++) { - - // printf("MIX i %d nclass %d eps %g sigma %g\n", - // i,n_amclass,vdwl_eps[i],vdwl_sigma[i]); - for (j = i; j <= n_amclass; j++) { + ei = vdwl_eps[i]; ej = vdwl_eps[j]; ri = vdwl_sigma[i]; @@ -2099,21 +2090,43 @@ void *PairAmoeba::extract(const char *str, int &dim) /* ---------------------------------------------------------------------- grow local vectors and arrays if necessary - keep them atom->nmax in length - NOTE: some of these do not need to grow unless nlocal > atom->nmax - these are ones that never store ghost values - could realloc them separately - e.g. thetai,igrid,fopt + some need space for ghost atoms, most do not ------------------------------------------------------------------------- */ void PairAmoeba::grow_local() { + // only reallocate if nlocal > nmax + + if (atom->nlocal > nmax) { + } + + + + // forward/reverse comm, so ghost values + uind; + uinp; + uopt; + uoptp; + rsd; + rsdp; + xred; // AMOEBA + + memory->destroy(rsd); + memory->destroy(rsdp); + memory->create(rsd,nmax,3,"amoeba:rsd"); + memory->create(rsdp,nmax,3,"amoeba:rsdp"); + + + memory->destroy(rpole); + memory->create(rpole,nmax,13,"amoeba:rpole"); + + + // free vectors and arrays memory->destroy(xaxis2local); memory->destroy(yaxis2local); memory->destroy(zaxis2local); - memory->destroy(rpole); memory->destroy(tq); if (amoeba) { @@ -2134,8 +2147,6 @@ void PairAmoeba::grow_local() memory->destroy(fieldp); memory->destroy(ufld); memory->destroy(dufld); - memory->destroy(rsd); - memory->destroy(rsdp); memory->destroy(zrsd); memory->destroy(zrsdp); @@ -2164,7 +2175,6 @@ void PairAmoeba::grow_local() memory->create(xaxis2local,nmax,"amoeba:xaxis2local"); memory->create(yaxis2local,nmax,"amoeba:yaxis2local"); memory->create(zaxis2local,nmax,"amoeba:zaxis2local"); - memory->create(rpole,nmax,13,"amoeba:rpole"); memory->create(tq,nmax,3,"amoeba:tq"); if (amoeba) { @@ -2185,8 +2195,6 @@ void PairAmoeba::grow_local() memory->create(fieldp,nmax,3,"amoeba:fieldp"); memory->create(ufld,nmax,3,"amoeba:ufld"); memory->create(dufld,nmax,6,"amoeba:dufld"); - memory->create(rsd,nmax,3,"amoeba:rsd"); - memory->create(rsdp,nmax,3,"amoeba:rsdp"); memory->create(zrsd,nmax,3,"amoeba:zrsd"); memory->create(zrsdp,nmax,3,"amoeba:zrsdp"); @@ -2212,96 +2220,3 @@ void PairAmoeba::grow_local() } } -// ---------------------------------------------------------------------- -// debug output methods -// ---------------------------------------------------------------------- - -/* ---------------------------------------------------------------------- - dump ID + 6 values from 2 (N,3) per-atom arrays - only proc 0 can write - file is already open -------------------------------------------------------------------------- */ - -void PairAmoeba::dump6(FILE *fp, const char *columns, double scale, - double **a, double **b) -{ - int i,j,m; - MPI_Status status; - MPI_Request request; - - // setup - - int size_one = 7; - int nlocal = atom->nlocal; - - char boundstr[9]; // encoding of boundary flags - domain->boundary_string(boundstr); - - int maxlocal; - MPI_Allreduce(&nlocal,&maxlocal,1,MPI_INT,MPI_MAX,world); - - double *buf; - memory->create(buf,maxlocal*size_one,"amoeba:buf"); - - // pack my data - - tagint *tag = atom->tag; - - m = 0; - for (i = 0; i < nlocal; i++) { - buf[m++] = tag[i]; - buf[m++] = scale*a[i][0]; - buf[m++] = scale*a[i][1]; - buf[m++] = scale*a[i][2]; - buf[m++] = scale*b[i][0]; - buf[m++] = scale*b[i][1]; - buf[m++] = scale*b[i][2]; - } - - // write file - - if (me == 0) { - fprintf(fp,"ITEM: TIMESTEP\n"); - fprintf(fp,BIGINT_FORMAT "\n",update->ntimestep); - fprintf(fp,"ITEM: NUMBER OF ATOMS\n"); - fprintf(fp,BIGINT_FORMAT "\n",atom->natoms); - fprintf(fp,"ITEM: BOX BOUNDS %s\n",boundstr); - fprintf(fp,"%-1.16e %-1.16e\n",domain->boxlo[0],domain->boxhi[0]); - fprintf(fp,"%-1.16e %-1.16e\n",domain->boxlo[1],domain->boxhi[1]); - fprintf(fp,"%-1.16e %-1.16e\n",domain->boxlo[2],domain->boxhi[2]); - fprintf(fp,"ITEM: ATOMS %s\n",columns); - } - - int nlines; - double tmp; - - if (me == 0) { - for (int iproc = 0; iproc < nprocs; iproc++) { - if (iproc) { - MPI_Irecv(buf,maxlocal*size_one,MPI_DOUBLE,iproc,0,world,&request); - MPI_Send(&tmp,0,MPI_INT,iproc,0,world); - MPI_Wait(&request,&status); - MPI_Get_count(&status,MPI_DOUBLE,&nlines); - nlines /= size_one; - } else nlines = nlocal; - - m = 0; - for (i = 0; i < nlines; i++) { - for (j = 0; j < size_one; j++) { - if (j == 0) fprintf(fp,"%d",static_cast (buf[m])); - else fprintf(fp," %g",buf[m]); - m++; - } - fprintf(fp,"\n"); - } - } - - } else { - MPI_Recv(&tmp,0,MPI_INT,0,0,world,MPI_STATUS_IGNORE); - MPI_Rsend(buf,nlocal*size_one,MPI_DOUBLE,0,0,world); - } - - // clean up - - memory->destroy(buf); -} diff --git a/src/AMOEBA/pair_amoeba.h b/src/AMOEBA/pair_amoeba.h index 0057219b98..5de382e2d9 100644 --- a/src/AMOEBA/pair_amoeba.h +++ b/src/AMOEBA/pair_amoeba.h @@ -159,7 +159,7 @@ class PairAmoeba : public Pair { // static per-atom properties, must persist as atoms migrate int index_amtype,index_amgroup,index_redID; - int index_xaxis,index_yaxis,index_zaxis,index_polaxe,index_pval; + int index_xyzaxis,index_polaxe,index_pval; int *amtype; // AMOEBA type, 1 to N_amtype int *amgroup; // AMOEBA polarization group, 1 to Ngroup From dbcc08ba00f2542b788727304a864b593608f042 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Tue, 17 May 2022 16:26:53 -0600 Subject: [PATCH 163/585] more refactoring for memory usage --- examples/amoeba/dump.ubi | 19492 ++++++++++++++++ examples/amoeba/dump.ubi.1.test | 19492 ++++++++++++++++ examples/amoeba/dump.ubi.32.test | 19492 ++++++++++++++++ examples/amoeba/dump.water_box.amoeba.1.test | 7227 ++++++ examples/amoeba/dump.water_box.amoeba.32.test | 7227 ++++++ examples/amoeba/dump.water_box.hippo.1.test | 7227 ++++++ examples/amoeba/dump.water_box.hippo.32.test | 7227 ++++++ .../amoeba/dump.water_dimer.amoeba.1.test | 165 + .../amoeba/dump.water_dimer.amoeba.4.test | 165 + examples/amoeba/dump.water_dimer.hippo.1.test | 165 + examples/amoeba/dump.water_dimer.hippo.4.test | 165 + .../amoeba/dump.water_hexamer.amoeba.1.test | 297 + .../amoeba/dump.water_hexamer.amoeba.4.test | 297 + .../amoeba/dump.water_hexamer.hippo.1.test | 297 + .../amoeba/dump.water_hexamer.hippo.4.test | 297 + examples/amoeba/in.ubiquitin.test | 56 + examples/amoeba/in.water_box.amoeba | 5 +- examples/amoeba/in.water_box.amoeba.test | 48 + examples/amoeba/in.water_box.hippo | 5 +- examples/amoeba/in.water_box.hippo.test | 48 + examples/amoeba/in.water_dimer.amoeba | 5 +- examples/amoeba/in.water_dimer.amoeba.test | 48 + examples/amoeba/in.water_dimer.hippo | 5 +- examples/amoeba/in.water_dimer.hippo.test | 48 + examples/amoeba/in.water_hexamer.amoeba | 5 +- examples/amoeba/in.water_hexamer.amoeba.test | 48 + examples/amoeba/in.water_hexamer.hippo | 5 +- examples/amoeba/in.water_hexamer.hippo.test | 48 + examples/amoeba/log.ubi.1.test | 162 + examples/amoeba/log.ubi.32.test | 162 + examples/amoeba/log.water_box.amoeba.1.test | 149 + examples/amoeba/log.water_box.amoeba.32.test | 149 + examples/amoeba/log.water_box.hippo.1.test | 153 + examples/amoeba/log.water_box.hippo.32.test | 153 + examples/amoeba/log.water_dimer.amoeba.1.test | 150 + examples/amoeba/log.water_dimer.amoeba.4.test | 150 + examples/amoeba/log.water_dimer.hippo.1.test | 154 + examples/amoeba/log.water_dimer.hippo.4.test | 154 + .../amoeba/log.water_hexamer.amoeba.1.test | 149 + .../amoeba/log.water_hexamer.amoeba.4.test | 150 + .../amoeba/log.water_hexamer.hippo.1.test | 153 + .../amoeba/log.water_hexamer.hippo.4.test | 154 + src/AMOEBA/amoeba_induce.cpp | 80 +- src/AMOEBA/amoeba_kspace.cpp | 1 - src/AMOEBA/amoeba_multipole.cpp | 52 - src/AMOEBA/amoeba_polar.cpp | 37 - src/AMOEBA/pair_amoeba.cpp | 247 +- src/AMOEBA/pair_amoeba.h | 20 +- 48 files changed, 91964 insertions(+), 221 deletions(-) create mode 100644 examples/amoeba/dump.ubi create mode 100644 examples/amoeba/dump.ubi.1.test create mode 100644 examples/amoeba/dump.ubi.32.test create mode 100644 examples/amoeba/dump.water_box.amoeba.1.test create mode 100644 examples/amoeba/dump.water_box.amoeba.32.test create mode 100644 examples/amoeba/dump.water_box.hippo.1.test create mode 100644 examples/amoeba/dump.water_box.hippo.32.test create mode 100644 examples/amoeba/dump.water_dimer.amoeba.1.test create mode 100644 examples/amoeba/dump.water_dimer.amoeba.4.test create mode 100644 examples/amoeba/dump.water_dimer.hippo.1.test create mode 100644 examples/amoeba/dump.water_dimer.hippo.4.test create mode 100644 examples/amoeba/dump.water_hexamer.amoeba.1.test create mode 100644 examples/amoeba/dump.water_hexamer.amoeba.4.test create mode 100644 examples/amoeba/dump.water_hexamer.hippo.1.test create mode 100644 examples/amoeba/dump.water_hexamer.hippo.4.test create mode 100644 examples/amoeba/in.ubiquitin.test create mode 100644 examples/amoeba/in.water_box.amoeba.test create mode 100644 examples/amoeba/in.water_box.hippo.test create mode 100644 examples/amoeba/in.water_dimer.amoeba.test create mode 100644 examples/amoeba/in.water_dimer.hippo.test create mode 100644 examples/amoeba/in.water_hexamer.amoeba.test create mode 100644 examples/amoeba/in.water_hexamer.hippo.test create mode 100644 examples/amoeba/log.ubi.1.test create mode 100644 examples/amoeba/log.ubi.32.test create mode 100644 examples/amoeba/log.water_box.amoeba.1.test create mode 100644 examples/amoeba/log.water_box.amoeba.32.test create mode 100644 examples/amoeba/log.water_box.hippo.1.test create mode 100644 examples/amoeba/log.water_box.hippo.32.test create mode 100644 examples/amoeba/log.water_dimer.amoeba.1.test create mode 100644 examples/amoeba/log.water_dimer.amoeba.4.test create mode 100644 examples/amoeba/log.water_dimer.hippo.1.test create mode 100644 examples/amoeba/log.water_dimer.hippo.4.test create mode 100644 examples/amoeba/log.water_hexamer.amoeba.1.test create mode 100644 examples/amoeba/log.water_hexamer.amoeba.4.test create mode 100644 examples/amoeba/log.water_hexamer.hippo.1.test create mode 100644 examples/amoeba/log.water_hexamer.hippo.4.test diff --git a/examples/amoeba/dump.ubi b/examples/amoeba/dump.ubi new file mode 100644 index 0000000000..743c5e68dc --- /dev/null +++ b/examples/amoeba/dump.ubi @@ -0,0 +1,19492 @@ +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +9737 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 5.4990000000000002e+01 +0.0000000000000000e+00 4.1909999999999997e+01 +0.0000000000000000e+00 4.1909999999999997e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 9.9631 5.60476 0.008413 6.29384 29.5246 19.0744 +2 2 9.59585 5.61686 40.5223 49.6095 -15.082 -19.7261 +3 2 8.19009 6.07902 40.3725 -38.3002 -36.0401 31.6494 +4 3 7.228 5.27674 40.5663 25.6537 34.3003 -15.2325 +5 4 9.24854 5.32486 0.671238 -4.4712 -3.37565 -7.28982 +6 4 10.3108 6.54317 0.309331 -11.8382 -28.5043 -8.77497 +7 4 10.7093 4.95217 0.170763 9.79439 -2.80927 4.02983 +8 4 10.3426 6.38567 40.0332 -19.5644 -29.2331 3.89265 +9 2 9.77742 4.13431 39.9813 -28.2245 -12.7597 2.79543 +10 2 9.48564 3.81758 38.4974 43.5672 -24.1926 -8.96475 +11 5 10.1176 2.11667 38.0047 -9.19737 11.9016 12.5734 +12 2 9.21456 1.10205 39.2112 31.2522 23.9396 11.6177 +13 4 8.99594 3.48122 40.5964 28.5446 19.8656 -13.413 +14 4 10.8136 3.75653 40.1807 -3.6049 4.77507 7.99264 +15 4 10.0744 4.47991 37.8007 -16.03 7.55553 14.4224 +16 4 8.42529 3.84402 38.2863 -20.8998 9.83371 -6.83213 +17 4 9.47601 1.46641 40.2263 -2.07893 -1.87234 0.341628 +18 4 9.53146 0.065851 39.1813 1.34892 -20.4385 -9.90461 +19 4 8.1577 1.22135 39.0727 -30.8502 -1.48556 -5.54631 +20 1 8.07565 7.408 40.3203 38.3461 4.68909 -14.5778 +21 2 6.84679 8.08521 40.1985 -59.0929 12.5985 8.76694 +22 2 6.18936 7.48414 38.9048 -11.7821 0.575019 41.3478 +23 3 6.7346 7.67531 37.8418 13.9355 0.826162 -41.115 +24 4 8.95137 7.92937 40.1018 -13.7432 5.12585 4.7357 +25 4 6.17099 7.78674 41.0889 17.7478 9.29385 -16.8634 +26 2 7.04543 9.68435 40.1788 6.06779 -36.4281 36.3417 +27 2 5.78315 10.5437 40.1541 10.0153 13.6856 -31.2349 +28 2 4.87823 10.4891 38.8981 8.0898 32.2503 -21.0798 +29 3 5.10035 11.2936 37.9551 -6.38068 -25.249 23.2549 +30 1 3.78765 9.69754 38.9447 7.74282 -10.5609 -2.0448 +31 4 7.77413 9.91905 39.4336 6.93206 10.4159 -38.5359 +32 4 7.65159 10.0279 41.0787 -15.5363 -12.6708 -2.68622 +33 4 6.21166 11.5927 40.0353 -14.0103 -9.11046 14.0038 +34 4 5.24199 10.4471 41.1154 -6.90019 6.03163 0.39253 +35 4 3.64982 9.13451 39.798 -8.63839 -3.4701 -4.98201 +36 4 3.18526 9.53497 38.0983 12.4509 11.2825 18.2671 +37 1 5.03649 6.76821 39.0271 29.2025 12.626 -49.9624 +38 2 4.1742 6.30537 37.9199 2.45922 -5.77224 11.4432 +39 2 2.7281 6.64357 38.2301 -33.27 13.9739 -28.2234 +40 3 2.48558 7.27851 39.247 -7.20167 1.94081 18.2399 +41 4 4.56901 6.92293 39.8729 -36.0812 -3.10094 47.9009 +42 4 4.41115 6.93099 37.0362 4.08063 -6.87028 -11.6053 +43 2 4.30896 4.77224 37.6863 5.60806 -34.2262 -10.7438 +44 2 3.61194 3.83713 38.7945 21.7291 41.8848 -7.6362 +45 2 5.81981 4.32753 37.5156 -0.302636 -10.5955 -12.2236 +46 2 3.74184 2.37563 38.4472 -21.3499 -20.7746 -35.862 +47 4 3.79188 4.51145 36.7016 6.3754 10.432 9.00978 +48 4 2.54774 4.08441 38.8361 -15.7139 1.18722 1.17999 +49 4 4.01487 4.13828 39.7949 0.987415 -11.5324 -1.87366 +50 4 6.38959 4.49596 38.46 -5.87199 -9.93517 1.91854 +51 4 6.36771 4.97617 36.7815 -14.8228 -10.6264 -0.132465 +52 4 5.90888 3.19548 37.1534 1.72477 39.701 11.5881 +53 4 3.39383 2.18531 37.3739 6.37275 7.50384 16.1992 +54 4 3.10231 1.69487 39.022 -2.76045 -1.11045 15.6564 +55 4 4.76015 2.00007 38.4839 16.883 -5.45935 8.37891 +56 1 1.68415 6.36719 37.3348 37.2769 -12.9922 15.6035 +57 2 0.304736 6.65563 37.6783 -19.186 -35.7743 -0.468083 +58 2 54.3638 5.41499 37.39 23.5408 9.01503 -19.9847 +59 3 54.8016 4.481 36.67 -18.0502 12.9096 17.6943 +60 4 1.81134 5.6821 36.5646 -2.38907 6.77101 2.69516 +61 4 0.26398 6.68603 38.7911 -5.02605 17.0245 3.77253 +62 2 54.6928 7.87629 36.9427 9.14228 37.5998 28.2049 +63 2 0.656467 9.08157 36.7109 -0.0956801 -8.96924 -14.639 +64 2 1.56488 9.23116 35.5658 -28.7887 -16.4207 21.28 +65 2 0.518242 10.1807 37.599 12.0453 -33.0617 -42.3022 +66 2 2.2549 10.4284 35.3456 -0.685553 9.51875 21.9154 +67 2 1.26608 11.2953 37.3573 -6.55985 56.8791 72.0683 +68 2 2.14201 11.4551 36.3269 43.9558 24.4422 -61.5967 +69 4 53.8494 8.28091 37.614 11.6877 -9.2043 -14.6276 +70 4 54.1796 7.56606 36.0251 1.84695 0.514683 -15.8045 +71 4 1.67027 8.40603 34.832 -2.56062 3.42592 3.08894 +72 4 54.8243 10.1788 38.4192 -16.1978 -2.83683 23.7337 +73 4 2.90465 10.5398 34.4584 1.04403 1.06161 3.93542 +74 4 1.2044 12.0958 38.199 3.2453 -15.1518 -32.2206 +75 4 2.76002 12.4636 36.1598 -24.4207 -43.5556 11.8549 +76 1 53.0705 5.5478 37.8043 -13.4682 25.7632 10.8407 +77 2 51.945 4.63101 37.5291 33.8243 -29.5042 -37.7332 +78 2 50.7838 5.44293 36.986 4.21111 -0.422475 -19.7833 +79 3 50.2621 6.29965 37.7355 -1.55474 -12.1519 -25.7528 +80 4 52.801 6.45436 38.3333 3.61532 -42.2821 -15.9338 +81 4 52.3053 3.83112 36.7028 -14.0928 30.7972 24.0178 +82 2 51.5456 3.79903 38.7793 9.75018 1.06621 4.26496 +83 2 50.3519 2.79661 38.4832 35.7171 10.1602 1.47909 +84 2 52.8174 3.02556 39.2171 -10.4567 -30.55 12.3487 +85 4 51.3202 4.51835 39.6193 -10.3559 -7.38818 -7.14654 +86 4 50.5612 2.13754 37.5331 -9.75373 16.6535 26.894 +87 4 49.4557 3.43665 38.3668 -10.8276 -7.01925 -6.76558 +88 4 50.2008 2.17632 39.4156 -2.83245 -1.1989 -13.0752 +89 4 53.3224 3.52205 40.064 3.32837 5.49303 2.41605 +90 4 53.5736 2.86114 38.4382 5.5955 2.25759 -8.48168 +91 4 52.5769 1.98664 39.5815 -0.855844 10.0945 -0.110617 +92 1 50.4393 5.19673 35.6351 -19.7264 9.67141 42.9571 +93 2 49.1691 5.71413 35.1171 8.57247 21.8964 -7.76629 +94 2 48.0882 4.65728 35.3507 -19.9883 30.8425 14.9148 +95 3 48.2827 3.53875 34.9335 -4.48089 -38.0316 -8.70437 +96 4 50.7426 4.33028 35.1784 2.31221 -1.81777 -1.86606 +97 4 48.9711 6.6281 35.7521 -11.2206 -0.672417 -16.6265 +98 2 49.2032 6.03091 33.5236 -0.851856 65.2811 26.1578 +99 2 47.9587 6.87959 32.9935 21.6676 -24.5773 11.3759 +100 2 48.0434 7.32811 31.5002 51.7858 -12.5586 -5.19204 +101 2 48.2074 6.22405 30.3724 28.294 -23.2516 17.4346 +102 1 48.1983 6.77555 28.9911 -71.9632 -28.6889 -6.605 +103 4 49.3393 5.11986 33.0139 -2.20502 -45.3575 -27.512 +104 4 50.0955 6.63289 33.1892 -0.645528 -4.64769 17.8413 +105 4 47.8013 7.74388 33.6913 1.36166 0.224784 -7.99748 +106 4 47.0904 6.22572 33.1496 -13.2574 -0.904539 -3.87726 +107 4 49.004 7.98659 31.3992 -27.9616 -9.11626 3.58403 +108 4 47.1978 7.96127 31.27 -20.0009 14.5444 -5.73856 +109 4 47.5417 5.33248 30.4619 -18.467 18.3391 -3.45282 +110 4 49.1897 5.66674 30.5732 -8.59668 22.4275 -14.4147 +111 4 48.9982 7.27964 28.7313 27.9214 19.6218 -9.55881 +112 4 47.3685 7.40493 28.8518 27.8731 -11.8414 7.77703 +113 4 48.0065 6.08598 28.2169 17.275 11.5652 28.2934 +114 1 46.9206 5.03778 35.9702 10.3577 18.9682 5.15831 +115 2 45.6557 4.25932 36.0398 9.08885 -0.641191 -14.1305 +116 2 44.8836 4.39003 34.674 17.924 -7.95306 73.8288 +117 3 45.3111 5.13887 33.8455 4.25406 24.8458 -47.415 +118 4 46.9247 5.98842 36.4259 -8.42518 -21.6093 -9.66 +119 4 45.9322 3.16772 36.074 -4.07513 2.77881 8.35057 +120 2 44.7235 4.66099 37.2497 -7.79148 27.6424 25.8282 +121 3 44.4559 6.1146 37.2032 37.085 -18.356 15.5747 +122 2 45.2448 4.26963 38.7181 22.7861 29.0575 -8.8559 +123 4 43.727 4.13168 37.1283 17.3832 10.5512 -0.864114 +124 4 45.2761 6.59903 37.5183 -34.0557 -21.4787 -11.7364 +125 4 45.8733 4.97275 39.4014 -10.271 -7.81482 -36.7347 +126 4 45.822 3.36133 38.5799 14.1835 -15.9263 3.29814 +127 4 44.4672 3.97387 39.4102 -27.3329 -5.40347 3.37723 +128 1 43.7561 3.68722 34.6039 -10.1769 -38.5504 10.0379 +129 2 42.7898 3.65331 33.5354 16.9998 -6.12306 -24.86 +130 2 41.7694 4.78815 33.7404 2.26966 -0.410412 -51.1213 +131 3 41.2522 5.37284 32.7445 13.6537 -18.3748 18.9894 +132 4 43.5295 2.98811 35.3697 5.99608 22.1557 -16.865 +133 4 43.3523 3.94914 32.5036 -19.5402 -19.5629 37.0771 +134 2 42.0755 2.18627 33.4863 21.9074 34.2086 -29.4327 +135 2 42.9391 0.859767 33.721 -6.85443 30.257 35.6042 +136 2 42.2358 41.4668 33.4285 -9.81834 -3.65893 -31.5778 +137 2 44.2283 0.854864 32.9471 53.2312 13.9788 40.9195 +138 4 41.6117 2.20331 32.4686 -4.39523 -13.2201 2.61812 +139 4 41.2586 2.27352 34.2121 -10.6776 -10.6054 4.67488 +140 4 43.2056 0.83773 34.8124 -0.343624 1.56324 -2.51079 +141 4 42.8118 40.5237 33.3983 6.69029 -0.569008 16.3673 +142 4 41.9597 41.5484 32.3684 -17.7546 -2.75522 -9.07631 +143 4 41.3245 41.3357 34.0216 -8.62626 -3.98831 3.9624 +144 4 44.0827 0.853311 31.8896 -3.53557 -4.02089 -36.565 +145 4 44.8236 41.822 33.2847 -5.06735 25.2561 -15.1823 +146 4 44.8583 1.80877 33.1923 -14.5958 -31.7921 -4.90526 +147 1 41.5264 5.19611 34.9737 -24.8334 44.6246 6.63495 +148 2 40.6685 6.33721 35.2699 -7.96634 19.3021 -16.1623 +149 2 41.3876 7.74941 35.097 -11.5591 -21.8484 1.81155 +150 3 40.7047 8.75309 34.8417 -6.4948 4.14558 0.128999 +151 4 41.7654 4.68652 35.8013 13.1043 -20.8107 18.8359 +152 4 39.8731 6.44712 34.4383 10.8594 -11.0445 14.3032 +153 2 39.8592 6.12601 36.6093 -15.5564 -7.24317 -37.5678 +154 3 40.7443 5.88444 37.6633 23.6025 16.5055 19.3857 +155 2 38.9047 4.85477 36.5395 -12.0583 61.1722 12.675 +156 4 39.322 7.07341 36.7706 -11.99 4.52079 9.89046 +157 4 41.1265 6.74598 37.8781 -3.93551 -10.4676 -4.79928 +158 4 38.0585 4.98564 35.7954 18.0693 -6.53498 -0.435941 +159 4 38.3566 4.77654 37.5171 8.14363 -6.92414 -3.72239 +160 4 39.543 3.99696 36.3828 0.165947 -30.6128 -6.86199 +161 1 42.7342 7.80416 35.136 -13.9315 11.8694 11.7976 +162 2 43.5142 9.02936 34.9481 17.7181 -46.9691 35.2138 +163 2 44.5073 9.42999 36.0349 -55.8537 -50.7646 50.0035 +164 3 45.375 10.2125 35.7599 43.422 25.9365 -4.74067 +165 4 43.1984 6.94617 35.4338 19.599 0.647333 4.29925 +166 4 44.1406 8.86955 34.0842 9.16679 3.97336 -28.1373 +167 4 42.9197 9.91228 34.8204 -18.5221 19.1219 -12.9063 +168 1 44.2798 8.93745 37.3587 -4.0043 10.1489 -58.0949 +169 2 45.1948 9.27519 38.4238 -4.17993 36.3676 -26.0855 +170 2 46.5575 8.73344 38.0061 12.5522 -20.4469 18.6928 +171 3 46.7331 7.49794 37.7681 -6.88831 31.8582 -6.20611 +172 4 43.377 8.45873 37.5311 9.37776 2.67644 11.4724 +173 4 45.2318 10.4158 38.3238 5.33405 -13.6354 14.6161 +174 2 44.7823 8.84756 39.8415 35.39 -32.4267 -9.44324 +175 2 45.5211 9.64049 40.9405 -33.0234 -16.4934 27.578 +176 2 45.0293 11.1067 41.0295 26.955 13.1382 1.75579 +177 2 45.9939 11.883 0.056845 5.44769 -3.52142 -7.77113 +178 1 45.567 13.2463 0.389189 -21.8942 22.5552 58.7427 +179 4 44.9649 7.71121 39.9163 -1.68078 22.7299 4.94117 +180 4 43.7292 8.96914 40.0006 -34.3585 3.91778 0.788359 +181 4 46.6326 9.56148 40.8729 -4.12637 -0.755434 -1.7729 +182 4 45.1589 9.15652 0.052119 21.5355 9.01144 -26.2886 +183 4 44.0384 11.1525 41.4882 -17.6691 -1.8484 1.78047 +184 4 44.9645 11.6456 40.0488 1.32443 -5.52779 3.51863 +185 4 46.9936 12.0079 41.4163 -11.0521 -7.71607 17.8496 +186 4 46.0863 11.2417 1.01939 6.64185 25.7549 -16.0759 +187 4 45.6176 13.9315 41.5535 6.39074 -1.54943 -2.93714 +188 4 46.1207 13.6426 1.21669 -15.3499 -18.2055 -38.2327 +189 4 44.572 13.3465 0.725918 28.6554 -12.4083 -12.8179 +190 1 47.5723 9.62675 38.0225 1.62241 16.525 -13.2778 +191 2 48.9413 9.31976 37.6447 28.3505 6.17866 3.85392 +192 2 49.7947 9.65595 38.897 -51.2415 76.6103 -24.0977 +193 3 49.6063 10.7902 39.4401 12.9093 -42.4425 -12.577 +194 4 47.4538 10.6389 38.3066 -1.81401 -22.4625 -4.08398 +195 4 49.0905 8.23756 37.4201 -8.03606 -0.867672 -0.903629 +196 2 49.3577 10.1392 36.3514 -15.5639 -8.86216 -34.5575 +197 3 48.3381 9.84531 35.2995 20.2521 4.60838 26.9691 +198 2 50.6821 9.73379 35.6575 -13.1705 -1.52152 26.2758 +199 4 49.443 11.2403 36.5183 -14.2645 -0.263993 8.70321 +200 4 47.5106 10.2398 35.5579 0.218555 2.62212 3.26783 +201 4 50.9323 10.3465 34.7687 -2.88514 -3.55444 -7.60949 +202 4 50.7732 8.65192 35.4951 -3.14548 -9.24106 -12.1943 +203 4 51.4763 9.94768 36.3674 17.1427 5.0591 10.0517 +204 1 50.5022 8.69828 39.4305 24.0939 -43.466 77.1583 +205 2 51.0483 8.71922 40.8082 -0.802123 10.2433 -32.8315 +206 2 52.5183 8.33859 40.7231 46.1376 25.1574 58.8821 +207 3 52.8914 7.33748 40.1143 13.0446 10.4001 -14.6089 +208 4 50.6189 7.73433 39.1341 -5.48208 -8.91176 -29.3848 +209 4 51.0045 9.75097 41.1725 -0.547397 17.2241 4.09797 +210 2 50.2922 7.85282 41.8455 19.6626 -50.7873 -7.63422 +211 2 50.2811 6.29504 41.471 -17.2864 -17.6708 26.7503 +212 2 48.8668 8.31684 0.212195 -17.3783 63.506 12.4232 +213 2 49.3691 5.38294 0.512646 14.3884 65.6628 -4.02696 +214 4 50.9326 7.9114 0.860642 -12.3241 5.1929 3.57402 +215 4 51.3127 5.83882 41.5287 -4.74499 10.5855 -5.5164 +216 4 49.8921 6.13652 40.4532 1.6457 0.843055 -11.9856 +217 4 48.0317 8.06123 41.424 13.0217 -7.20036 -2.54126 +218 4 48.8693 9.49201 0.254246 -0.917701 -32.4673 -2.46528 +219 4 48.5263 8.05212 1.23597 1.41612 -6.96817 -0.649274 +220 4 48.2816 5.57755 0.309314 6.34191 -1.32326 5.14384 +221 4 49.6363 5.72968 1.56057 -11.1106 -15.1353 -5.99489 +222 4 49.54 4.32324 0.397743 7.27301 -24.1582 -2.3836 +223 1 53.3925 9.14738 41.5454 -19.7766 -15.6836 -47.6014 +224 2 54.8543 9.29866 41.641 -12.5045 -20.0873 29.727 +225 2 0.407838 8.25913 0.762984 -29.7207 32.5524 -37.8245 +226 3 54.8643 8.2564 1.86493 17.0269 -29.0845 20.332 +227 4 52.9285 9.69819 0.341812 -9.11605 14.2566 13.2302 +228 4 0.291486 9.0623 40.6877 9.99865 -5.39191 -34.8298 +229 2 0.359683 10.7121 0.203065 -6.90664 -3.88067 -14.6485 +230 3 54.4765 11.8025 41.752 -11.2022 -21.2627 -5.88002 +231 2 1.6614 11.1001 41.4135 2.5167 -27.9916 -13.3179 +232 4 0.487415 10.6137 1.28953 0.410521 18.1219 13.0764 +233 4 54.0953 12.1937 0.613553 1.59003 1.59721 11.7532 +234 4 1.92456 12.0955 41.7398 14.8193 23.7252 4.53742 +235 4 1.52762 11.126 40.2979 3.61624 1.93597 7.36374 +236 4 2.5241 10.4069 41.6364 -8.38015 7.04993 1.52106 +237 1 1.45864 7.53391 0.367476 0.545631 9.71791 -21.8799 +238 2 2.25081 6.65311 1.15507 26.446 -0.0641839 -18.4938 +239 2 3.7671 6.96757 0.917085 -57.4365 -22.4689 85.9929 +240 3 4.15047 7.41488 41.7757 21.4144 12.1214 -29.7802 +241 4 1.8001 7.62601 41.3064 3.76941 -0.348546 3.21752 +242 4 1.98413 6.84865 2.19976 1.77378 -4.57114 13.3572 +243 2 1.98593 5.20856 0.673411 -39.0557 8.05152 -2.47083 +244 2 0.499001 4.77546 0.950638 51.92 -35.3278 3.54994 +245 2 0.302449 3.38226 0.307039 12.2804 5.92691 27.6936 +246 2 0.318833 4.59091 2.46762 -57.1886 17.9845 23.4913 +247 4 2.62035 4.47984 1.15306 24.0478 -12.5257 10.4353 +248 4 2.17019 5.14075 41.4887 6.74012 -0.473312 -2.7006 +249 4 54.8482 5.46061 0.448133 -33.0903 28.7369 -7.07308 +250 4 54.2241 3.15851 0.337643 -14.6094 -12.7265 -2.24176 +251 4 0.881511 2.58656 0.876485 -8.96903 11.0382 -11.5819 +252 4 0.635114 3.38296 41.1822 2.70741 -4.49002 -20.1461 +253 4 0.991181 3.80938 2.86091 2.53728 -4.51346 7.06316 +254 4 54.1796 4.30541 2.72425 38.6722 3.44969 -10.622 +255 4 0.495432 5.52724 3.08531 2.73328 -11.7655 -13.2166 +256 1 4.49387 6.66874 2.05101 59.25 35.5651 -63.8633 +257 2 5.97745 6.82619 2.08157 -13.5783 -40.6566 -15.6714 +258 2 6.57448 5.47381 2.54294 67.6927 12.9151 50.3283 +259 3 7.53922 5.43765 3.33186 -5.78511 6.85237 -12.8739 +260 4 4.10191 6.33546 2.9164 -11.2688 -10.0369 11.6191 +261 4 6.35409 6.85375 1.02753 1.73229 12.3732 3.55997 +262 2 6.47001 8.00523 2.96248 -35.1701 -2.47648 -9.01657 +263 2 6.52316 9.38515 2.26526 -52.089 -36.3571 -52.5381 +264 2 6.66039 10.5311 3.17647 23.2175 30.5211 32.7092 +265 3 7.81872 10.9467 3.49478 5.10838 -9.19539 -6.96115 +266 3 5.64173 11.0573 3.6767 -20.5888 -1.64097 0.158765 +267 4 7.42654 7.87231 3.41702 35.4584 -16.2138 5.63399 +268 4 5.81838 7.86205 3.84167 -4.54492 27.3919 10.2645 +269 4 5.56237 9.49095 1.59664 20.5708 1.89307 25.306 +270 4 7.29681 9.38215 1.47849 13.2355 1.21078 1.19218 +271 1 6.08096 4.31767 2.17259 -39.414 -15.8224 -24.7678 +272 2 6.39518 2.91476 2.36043 4.12081 37.0723 19.1814 +273 2 7.75633 2.62628 1.79624 63.8838 -9.4865 -25.3011 +274 3 8.33634 3.36937 0.946953 -27.4154 -16.213 26.3787 +275 4 5.28658 4.43126 1.58002 -24.0887 -1.16266 -20.2566 +276 4 6.54455 2.77577 3.45017 -8.86613 -5.70482 8.60941 +277 2 5.25427 2.02933 1.82805 -30.6144 -48.6247 5.61864 +278 2 3.85552 2.1153 2.66383 78.486 27.413 32.1434 +279 2 4.87851 2.27508 0.297641 -10.4566 -15.7718 22.2154 +280 4 5.65998 0.937168 1.99721 -15.6319 23.5495 -14.0675 +281 4 3.98898 1.63213 3.72107 -1.04911 23.3354 -24.3429 +282 4 3.15409 1.48884 2.20213 -45.477 -24.0418 -26.2275 +283 4 3.51802 3.20813 2.70746 -2.40249 -20.6527 6.6832 +284 4 4.39172 3.24426 0.119355 -1.44384 9.21297 0.0772101 +285 4 4.19746 1.51559 41.6955 12.4172 8.09212 16.5491 +286 4 5.82002 2.28129 41.6778 17.5327 1.3005 -22.4945 +287 1 8.43941 1.53208 2.30673 1.7292 42.4201 -39.4356 +288 2 9.76672 1.10452 1.81012 11.995 -19.5667 23.3003 +289 2 9.60964 41.7637 0.921245 4.05677 21.7498 -11.1929 +290 3 8.59567 41.087 1.06007 7.18507 -15.5872 -8.58634 +291 4 7.90606 0.81761 2.76924 -8.42032 -19.931 16.3865 +292 4 10.4026 1.87877 1.34085 -18.5158 15.1062 -12.7744 +293 2 10.6232 0.647963 3.0246 -34.7832 -39.5023 14.4787 +294 2 11.0993 1.6812 4.04079 16.2934 16.5377 23.708 +295 2 12.4719 2.27616 3.59128 -46.8378 -2.52013 6.7155 +296 3 13.4675 1.63575 4.02276 22.0629 14.477 -13.463 +297 3 12.4471 3.24187 2.73298 15.8946 -22.2661 28.0778 +298 4 11.4641 0.045385 2.63277 10.8271 5.92943 5.75519 +299 4 10.0353 41.7446 3.607 8.35649 20.5438 -12.0897 +300 4 11.2832 1.11765 5.0427 -4.51453 13.9694 -21.6118 +301 4 10.341 2.4932 4.3105 9.65416 -13.2167 -8.7997 +302 1 10.6494 41.4676 0.039711 8.78515 0.440053 18.9323 +303 2 10.7217 40.2184 41.1909 10.2574 -28.5822 12.1248 +304 2 10.6889 38.8907 0.171469 -17.3791 70.2346 -13.2363 +305 3 10.1368 37.8928 41.652 0.864281 -20.5458 12.6113 +306 4 9.82473 40.2067 40.5786 -14.2689 -8.84554 -18.4029 +307 2 12.0478 40.1799 40.3262 -31.3786 20.6535 10.6233 +308 2 12.4388 41.6551 40.4794 16.223 20.8678 -10.392 +309 2 11.8805 0.34241 41.7792 -28.1233 -36.7072 -34.4959 +310 4 11.9102 39.8982 39.2292 -1.08614 0.893428 17.4874 +311 4 12.7409 39.4563 40.8087 9.93344 3.46544 -3.32375 +312 4 12.0845 0.391154 39.5895 8.62314 -16.2997 14.2071 +313 4 13.5502 41.7447 40.5643 -1.70925 0.910467 -12.4735 +314 4 11.7305 1.40344 41.6414 -9.5626 24.5309 -2.35213 +315 4 12.5687 0.26268 0.684216 19.8182 -9.73862 27.9097 +316 1 11.1854 39.0885 1.40191 34.1901 -11.3327 18.3686 +317 2 11.4785 38.09 2.41707 -37.5808 13.2867 4.32174 +318 2 10.2405 37.7763 3.3402 -0.155099 -13.1844 6.87934 +319 3 10.4378 36.9653 4.27207 -11.6928 9.67513 -22.7546 +320 4 11.6756 39.9703 1.62918 -8.97807 -2.58442 -2.36164 +321 4 11.7153 37.147 1.89269 -3.37493 -11.1801 -2.58831 +322 2 12.7263 38.4682 3.25859 -32.7454 -15.529 27.3397 +323 3 12.5885 39.7408 3.87129 1.54426 18.5893 -11.5354 +324 4 13.5945 38.4441 2.61946 23.9879 5.88222 -14.7576 +325 4 12.9197 37.685 4.04183 -3.566 10.9198 -2.82194 +326 4 11.9285 39.8531 4.57214 8.5625 -16.1459 -5.7164 +327 1 8.98961 38.3717 3.14779 19.3135 28.1448 -76.0315 +328 2 7.78009 38.1002 3.90315 -4.26896 22.0341 0.229441 +329 2 6.83069 37.1869 3.18241 -25.8564 -25.3069 -16.1867 +330 3 6.84398 36.9785 1.97125 20.9058 23.903 -13.4458 +331 4 8.79049 38.9506 2.20714 10.5577 -30.8167 54.9659 +332 4 8.11274 37.5073 4.75427 1.14536 -6.32615 23.8911 +333 2 7.0077 39.4163 4.32571 4.21253 -4.87986 18.678 +334 2 7.75781 40.1168 5.42156 46.58 -14.1846 12.934 +335 3 8.30143 41.2262 5.21331 -14.6188 11.6514 -5.86083 +336 3 8.10545 39.4797 6.46784 -18.045 3.20128 -4.6129 +337 4 6.01572 39.173 4.78754 -1.72287 0.045533 -10.2864 +338 4 6.87032 40.2048 3.55457 -4.98407 -10.6589 -12.5629 +339 1 5.91154 36.4899 3.88964 18.6928 -0.691686 25.3425 +340 2 4.98537 35.571 3.20749 -24.0931 31.8814 30.8723 +341 2 3.79198 36.4499 2.67545 58.5623 50.3783 54.6165 +342 3 3.60244 37.6478 3.05835 4.98938 -42.2114 -12.2812 +343 4 5.945 36.5545 4.93654 -10.5756 -4.83423 -16.3239 +344 4 5.5221 35.038 2.40161 -3.05594 2.46612 -11.4716 +345 2 4.40384 34.4728 4.15145 -1.70261 45.9252 5.92389 +346 3 3.98498 35.0725 5.41787 -8.00202 -46.5665 -16.5053 +347 2 5.48475 33.4747 4.46048 0.249803 -29.9924 71.6177 +348 4 3.54337 34.0389 3.61058 -6.82183 -12.9435 7.69028 +349 4 3.62675 34.2747 5.86698 6.39679 27.749 2.05336 +350 4 5.85279 32.9868 3.57629 11.3184 -16.9973 -22.3871 +351 4 5.09248 32.6743 5.23041 8.97186 17.4623 -32.7541 +352 4 6.34746 33.9006 5.03324 -0.476546 4.78606 -11.5797 +353 1 3.00152 35.8184 1.87366 -46.1462 -42.5584 -55.0681 +354 2 1.77021 36.3468 1.35692 -36.7765 14.163 11.1031 +355 2 0.721356 36.5788 2.57059 18.2386 -29.7925 23.2574 +356 3 54.9678 37.5551 2.63992 10.9193 3.0322 -8.68025 +357 4 3.31287 34.9586 1.40066 1.19836 -3.77239 4.28893 +358 4 2.05059 37.3327 0.922928 -11.4048 10.7741 9.22697 +359 2 1.07197 35.5705 0.158527 41.3495 -39.9506 -9.05678 +360 2 1.73776 35.9497 40.6674 -26.4234 39.8053 33.0301 +361 2 54.5322 35.7209 0.133627 -14.8072 -12.0564 -1.20894 +362 2 3.23928 35.9487 40.63 7.11928 -24.1756 -12.68 +363 4 1.32474 34.4514 0.269568 -7.211 20.0201 5.35532 +364 4 1.47926 37.0502 40.6385 -3.87579 -7.90549 -26.2729 +365 4 1.36122 35.3789 39.7771 -4.72819 3.84386 12.155 +366 4 54.087 35.0558 41.2526 3.68912 7.63158 3.17282 +367 4 54.2076 36.7772 41.8385 0.949253 -6.55132 4.09096 +368 4 54.0676 35.3362 1.10912 4.22691 12.456 -17.368 +369 4 3.57003 34.9443 40.8434 9.13412 -24.8126 8.40569 +370 4 3.78301 36.5792 41.3142 5.34684 18.5101 18.1918 +371 4 3.6567 36.127 39.6372 -0.20476 7.44967 -14.9904 +372 1 0.712989 35.6055 3.58431 38.0557 9.26554 -59.6495 +373 2 0.05279 35.6483 4.83915 -15.0961 2.42646 38.658 +374 2 0.191347 37.0144 5.48801 7.00468 33.8104 1.40802 +375 3 54.154 37.7008 5.76148 35.4113 -11.6645 -8.2681 +376 4 1.23482 34.733 3.35856 -11.2418 4.01634 10.8504 +377 4 53.9671 35.581 4.69172 -20.2496 -5.13772 -12.456 +378 2 0.463881 34.4895 5.81355 17.031 15.9659 -33.5139 +379 2 54.8083 34.3393 7.16558 -30.7527 -16.2072 -11.1445 +380 2 0.00712 35.4957 8.10271 3.59003 -8.69902 15.3198 +381 3 54.0967 36.3529 8.34542 -1.77732 -9.94333 -12.6544 +382 3 1.07192 35.4587 8.7399 35.3598 16.353 18.5034 +383 4 1.56574 34.5304 5.94519 0.590681 0.639559 4.32925 +384 4 0.280894 33.5741 5.23349 -1.52963 -16.3279 0.16603 +385 4 0.223173 33.3947 7.64873 -6.8885 8.42796 -3.46601 +386 4 53.7112 34.1554 6.97481 9.65493 -2.46487 7.60139 +387 1 1.50649 37.4152 5.65526 -22.458 -31.2308 -17.0045 +388 2 2.02438 38.6379 6.15097 -3.22056 29.1656 36.4104 +389 2 1.58588 39.8651 5.40701 -13.5031 20.9194 -76.104 +390 3 1.07209 40.8553 5.93778 8.03965 -15.1327 11.1864 +391 4 2.24702 36.741 5.38136 -6.00826 1.88497 2.51587 +392 4 1.72629 38.833 7.20228 -22.1923 -11.9073 0.0585309 +393 2 3.51949 38.6121 6.24971 43.6984 -50.5664 -0.0787057 +394 2 4.11017 39.7004 7.10642 -5.48661 12.2779 -12.8977 +395 3 4.55887 40.7033 6.57435 6.12607 11.2234 -5.55098 +396 1 3.97545 39.5562 8.42942 -13.6958 7.00999 41.6346 +397 4 3.92653 38.5973 5.19958 6.67843 9.43594 11.2804 +398 4 3.90699 37.6191 6.72902 -10.8805 23.4385 -12.7616 +399 4 3.35162 38.8096 8.83526 13.2612 9.60447 -6.60232 +400 4 4.25023 40.3377 9.09595 -2.56729 -20.1743 -21.9158 +401 1 1.64621 39.8034 3.99517 -50.1719 52.4074 67.8966 +402 2 0.960547 40.8538 3.14427 -3.37695 -31.9032 -17.009 +403 2 54.4047 41.0035 3.47138 71.1401 19.2662 2.3079 +404 3 53.9887 0.221409 3.63964 -22.8765 18.4333 9.81455 +405 4 2.07659 38.9926 3.63308 18.9969 -31.9912 -34.7926 +406 4 1.39808 41.8727 3.34889 0.835518 -9.01277 1.27119 +407 2 1.14841 40.4887 1.56595 -9.49555 20.2148 39.7014 +408 2 0.469253 41.6189 0.677094 10.8075 11.2475 47.495 +409 2 2.6528 40.4777 1.25625 -15.459 -47.3647 -39.6369 +410 4 0.776571 39.4398 1.40308 -11.1955 11.1351 -6.38222 +411 4 54.3852 41.8501 0.825468 -5.0709 -17.7069 -2.05205 +412 4 0.696071 41.5065 41.5456 0.0730393 -4.82529 -32.9133 +413 4 0.904174 0.691668 0.985463 6.30616 -9.41897 -5.2369 +414 4 2.64269 40.3122 0.13166 16.7998 18.1471 15.5753 +415 4 3.13789 39.5289 1.58622 -1.56816 4.1145 9.56394 +416 4 3.29805 41.2779 1.59825 6.1243 20.9887 1.16769 +417 1 53.684 39.9214 3.65257 -36.1976 13.6917 8.19643 +418 2 52.3006 39.9493 4.06589 -56.8626 -17.5359 -10.0305 +419 2 52.042 40.5256 5.46425 9.62461 10.2848 -5.14962 +420 3 51.0331 41.2228 5.70144 14.4944 -11.372 -4.23176 +421 4 54.0189 39.0607 3.30247 15.8062 -40.5534 -6.95561 +422 4 51.6931 40.6476 3.38276 19.0563 -8.07776 7.22418 +423 2 51.5622 38.4976 3.96193 14.5706 2.1127 21.5154 +424 2 51.4158 37.9814 2.50572 24.752 -20.928 -15.9835 +425 2 51.0077 36.4305 2.37064 11.3099 30.9145 9.08043 +426 2 50.8522 35.9939 0.907307 -46.4939 -7.09254 -49.7464 +427 1 50.1475 34.7025 0.671588 69.6077 -32.405 2.84717 +428 4 50.6006 38.4842 4.55016 3.73478 6.81079 -18.2086 +429 4 52.1831 37.7463 4.55262 -3.81101 12.3643 -13.1539 +430 4 52.4118 38.1657 2.02278 1.77015 -18.5404 7.48984 +431 4 50.8584 38.5927 1.79489 -26.3581 9.74254 8.34414 +432 4 50.0453 36.2246 2.88499 -2.56193 3.57961 3.68626 +433 4 51.7703 35.8375 2.92238 0.215708 -6.73604 -5.33103 +434 4 51.7691 36.0437 0.240386 -6.2594 -4.10885 19.6388 +435 4 50.1039 36.686 0.3716 22.9763 1.60597 16.3794 +436 4 50.5914 33.8993 1.10828 2.95648 12.8391 18.7814 +437 4 50.3001 34.3737 41.6268 -19.3387 19.3411 -4.27099 +438 4 49.2006 34.6111 0.961468 -24.084 7.88088 -0.582308 +439 1 53.0235 40.2561 6.35237 -32.3128 10.4579 -5.0201 +440 2 53.1129 40.7256 7.70074 -41.6363 -1.15369 57.3167 +441 2 53.1798 0.352689 7.77253 -34.9991 -20.8035 37.2736 +442 3 52.5119 1.01286 8.63006 21.7579 -17.6925 -30.8538 +443 4 53.6931 39.5673 6.06584 22.7894 -18.2937 1.39271 +444 4 52.0865 40.4844 8.3065 35.7608 3.68212 -29.1988 +445 2 54.2701 40.0034 8.46069 6.08948 28.5921 -6.02695 +446 4 54.5971 40.5153 9.39975 -22.234 -14.34 10.1754 +447 4 0.201561 40.2092 7.93116 13.6903 -2.08726 -21.3806 +448 4 54.1655 38.8939 8.41526 -0.559105 0.118215 15.5404 +449 1 53.9752 0.884949 6.87383 32.3465 35.364 -24.1241 +450 2 54.062 2.35993 6.75215 -1.13821 -0.709889 -34.8218 +451 2 52.7471 3.02097 6.14186 4.92946 35.4069 59.7439 +452 3 52.3227 4.16587 6.4978 18.9545 -33.4145 3.00952 +453 4 54.7345 0.266534 6.4753 -18.8262 24.4346 -1.05702 +454 4 54.2802 2.76759 7.79054 -12.1814 3.84369 -14.3249 +455 2 0.185451 2.81859 5.73187 27.2059 46.9588 30.4236 +456 2 1.71808 2.36893 6.1571 -63.9259 -20.0653 -29.4315 +457 2 1.9764 2.63004 7.63437 43.6306 13.7343 2.97159 +458 2 3.27263 1.81187 8.04275 -33.9139 -3.58936 -6.58926 +459 1 3.78328 2.11956 9.34176 26.6398 21.4152 24.507 +460 4 0.173809 4.01773 5.82442 4.54198 -39.0295 -6.50933 +461 4 54.8792 2.64498 4.65574 11.0791 -10.5686 10.592 +462 4 2.43618 2.90609 5.45978 -2.35628 -10.1976 10.4282 +463 4 1.76796 1.2289 6.01344 4.57023 21.5888 -8.89179 +464 4 1.21473 2.41369 8.37281 -19.449 -19.8593 5.28327 +465 4 2.02309 3.72579 7.75906 18.9296 5.96095 -1.30777 +466 4 4.11389 1.88412 7.33652 2.51142 0.584915 -8.00636 +467 4 2.91513 0.727469 8.06593 14.1612 11.4678 0.952909 +468 4 3.87966 1.33238 9.93849 2.65093 -23.7146 9.43734 +469 4 3.29203 2.7681 9.89323 -42.3935 13.6729 9.41431 +470 4 4.65765 2.6209 9.4154 12.4458 -11.5538 -21.8273 +471 1 52.0387 2.32512 5.28273 -51.3661 -11.8477 -11.6622 +472 2 50.6641 2.72274 4.84157 25.7857 6.93126 13.1254 +473 2 49.5414 2.57609 5.91007 27.6149 -7.37739 5.45836 +474 3 48.7805 3.52104 6.09585 -8.9672 -1.93713 4.87304 +475 4 52.4681 1.55108 4.79165 6.19099 -18.5603 -5.58783 +476 4 50.6769 3.82983 4.70864 1.41274 -1.50214 -10.3294 +477 2 50.3587 2.05695 3.49156 -22.4167 -18.5545 -8.10533 +478 2 51.392 2.35646 2.3419 -24.5199 12.8001 2.40788 +479 2 48.9327 2.41504 2.97856 -9.14079 -2.86031 26.3031 +480 2 51.1945 1.4129 1.15651 29.522 -13.6455 -15.5517 +481 4 50.3189 0.937191 3.7523 9.08136 15.4094 -11.3523 +482 4 52.3823 2.12188 2.68097 31.5971 -0.36407 15.4796 +483 4 51.4014 3.46798 2.06765 -1.078 -19.9026 -0.0406259 +484 4 48.2117 2.12758 3.78451 -1.04241 22.2186 2.00084 +485 4 48.5813 1.67256 2.28636 2.21501 -12.0529 -35.8697 +486 4 48.7327 3.44552 2.54328 5.48386 -12.5705 11.3103 +487 4 52.1623 1.3706 0.452926 -36.5132 5.61179 20.4585 +488 4 50.2881 1.70969 0.600596 -1.11419 -0.409473 -10.6314 +489 4 51.0211 0.353877 1.53511 3.53067 13.7442 -8.50616 +490 1 49.5623 1.51743 6.77214 29.0905 -0.0770965 -25.5222 +491 2 48.7084 1.41716 7.91723 -3.12505 -21.6463 4.96918 +492 2 48.8549 2.61932 8.82546 31.903 20.2748 29.0475 +493 3 47.906 3.05048 9.46897 -16.8524 2.35798 -10.3438 +494 4 50.2118 0.710522 6.59294 -12.9921 18.0739 4.61122 +495 4 47.6425 1.393 7.52359 9.91609 0.328738 10.372 +496 2 49.0787 0.089334 8.73016 -60.0302 -9.6098 -44.8862 +497 2 48.2852 41.7441 10.0242 3.18066 15.7764 -9.96769 +498 2 46.7826 0.060746 9.96682 -2.34726 -14.6607 41.7592 +499 3 46.2233 0.511631 10.9878 -5.96974 4.10403 -23.4495 +500 1 46.1388 41.3329 8.97776 32.9533 20.065 15.0282 +501 4 50.1182 0.035639 8.93296 42.8084 2.68407 12.3764 +502 4 48.8904 41.1121 8.0025 3.88899 17.9501 19.4277 +503 4 48.6104 0.602172 10.7954 4.73737 -18.8132 -0.914642 +504 4 48.4759 40.6816 10.3394 0.165969 9.19265 10.3013 +505 4 46.673 40.8953 8.25882 14.2049 -15.3063 -26.5369 +506 4 45.1569 41.364 8.91958 -49.0994 -2.53611 0.320683 +507 1 50.1114 3.13932 9.06291 -28.12 32.8195 0.337886 +508 2 50.3404 4.32895 9.98795 -1.65029 -57.226 -17.8628 +509 2 50.0322 5.66893 9.41362 -36.2334 -9.83443 -38.9072 +510 3 49.3598 6.44562 10.1062 15.3309 6.40082 -5.38514 +511 4 50.9085 2.84633 8.5071 12.3092 -10.0263 -3.45928 +512 4 49.5835 4.28149 10.7848 -3.38143 -13.253 14.1405 +513 2 51.7461 4.22789 10.5468 25.7206 14.4209 20.1557 +514 2 51.9023 5.17188 11.7283 -67.9962 -1.36338 64.1829 +515 3 50.9364 5.19004 12.6002 28.9599 1.18541 -41.9912 +516 3 52.9319 5.83594 11.9785 18.8411 2.87417 -24.5577 +517 4 52.4276 4.5214 9.72474 12.6887 -3.13287 0.413374 +518 4 52.058 3.21563 10.9647 -9.24198 7.66389 -16.6414 +519 1 50.112 5.78532 8.03139 7.52033 29.602 25.459 +520 2 49.6799 7.08933 7.40639 14.3534 -30.8181 22.5674 +521 2 48.2409 7.17209 6.9711 -2.24553 44.7474 7.57528 +522 3 47.5844 8.22961 7.08968 18.1939 -9.81929 5.41459 +523 4 50.7064 5.09112 7.53173 -12.638 14.3936 -6.22521 +524 4 49.7159 7.84119 8.19837 -7.36252 7.51614 21.2329 +525 2 50.7023 7.64954 6.44039 -16.0213 -40.4967 -48.4302 +526 2 50.7257 6.82423 5.08423 -13.7427 47.9405 2.4816 +527 2 51.6418 7.28287 3.94021 29.8472 39.248 73.299 +528 2 53.127 6.98483 4.24688 1.29977 19.7271 -18.9866 +529 1 53.757 7.95176 5.17575 -11.1866 13.844 -62.5277 +530 4 51.636 7.68275 6.97838 28.3767 1.23741 1.58475 +531 4 50.4129 8.66535 6.18803 -0.179632 23.7408 -3.11047 +532 4 49.7187 7.01043 4.64523 -5.97611 -10.1095 1.48316 +533 4 50.8061 5.7562 5.2149 3.4405 -22.8364 10.0865 +534 4 51.5118 8.41472 3.72654 -1.36136 -26.6124 -3.74792 +535 4 51.4228 6.66542 3.12568 -20.7249 -22.8033 -58.4365 +536 4 53.6095 7.03345 3.2004 3.85152 5.93338 28.8514 +537 4 53.3314 5.96083 4.57939 -0.112253 -9.13532 8.29834 +538 4 53.309 8.86524 5.1699 0.162268 -2.42959 1.84412 +539 4 54.6672 8.17057 4.81193 19.2107 -0.812718 7.6593 +540 4 53.869 7.69009 6.11536 0.991087 -15.435 33.6166 +541 1 47.7293 6.1299 6.36528 -13.6545 -50.1986 -45.913 +542 2 46.4151 6.11998 5.73127 12.5517 -4.35851 26.1033 +543 2 45.4457 5.24236 6.50095 -54.5114 -4.35957 -22.3583 +544 3 44.2134 5.34166 6.22856 33.5613 3.36987 15.344 +545 4 48.2957 5.29705 6.08439 -4.65701 16.0313 11.2062 +546 4 46.0246 7.14829 5.83676 -12.413 4.85954 -1.2939 +547 2 46.3966 5.7006 4.23247 16.9743 -35.0719 19.3242 +548 2 46.8471 6.79722 3.31369 7.95245 13.9142 -51.9109 +549 2 46.0679 8.12855 3.29075 19.7668 12.2354 20.4517 +550 3 44.9703 8.28242 2.6836 -5.20426 -7.76074 -7.99938 +551 3 46.5716 9.08042 3.9624 -5.49585 -3.27174 -8.75295 +552 4 45.3525 5.37075 3.98324 7.30106 1.55378 -6.68576 +553 4 47.1483 4.79199 4.10624 -28.8106 21.423 0.303262 +554 4 47.0017 6.41037 2.24023 -12.0684 6.13088 18.9752 +555 4 47.8815 7.05675 3.60692 6.175 4.12296 2.89493 +556 1 45.8802 4.28795 7.34048 -32.7588 9.8199 -6.22093 +557 2 44.9801 3.41661 8.05582 7.11941 -0.762777 6.83491 +558 2 44.2841 2.32798 7.24802 57.2007 25.2815 -35.4523 +559 3 43.4338 1.62321 7.71908 -38.784 -24.7635 26.1598 +560 4 46.8556 4.13399 7.46211 34.7056 -9.13536 7.69054 +561 4 45.5867 2.90913 8.82837 -2.10841 -5.06197 5.41207 +562 4 44.2233 4.00883 8.63057 1.71074 -0.990438 -6.10924 +563 1 44.7516 2.08483 5.98824 -37.8462 -38.4135 -8.16449 +564 2 44.1597 1.01431 5.13579 -9.65639 -34.378 14.28 +565 2 44.8664 41.5016 5.49089 -11.1964 37.9598 3.64882 +566 3 46.103 41.4369 5.57345 -11.1149 2.47206 2.88353 +567 4 45.5262 2.474 5.47152 21.0389 22.2918 12.8005 +568 4 43.0172 0.862184 5.40503 31.5022 14.6416 -15.142 +569 2 44.4162 1.4085 3.60515 5.8653 -21.2021 14.2009 +570 2 43.5161 2.65984 3.27425 41.0117 -18.0627 24.5931 +571 2 44.2213 0.116838 2.67583 -30.001 3.65408 12.6342 +572 2 43.604 3.10049 1.82796 -41.0466 14.5447 22.3036 +573 4 45.4923 1.71966 3.57573 -0.138156 -3.02814 -11.6903 +574 4 43.8008 3.50537 3.97163 -2.46499 -4.10631 -11.566 +575 4 42.524 2.38704 3.60859 -29.3388 -0.685173 -5.23931 +576 4 44.5714 0.285197 1.65031 -2.2735 9.46305 -11.1841 +577 4 43.1006 41.7553 2.65834 21.2852 6.7215 -5.00379 +578 4 44.7366 41.0658 2.93547 0.768749 11.7185 9.28335 +579 4 44.5004 3.68719 1.60884 14.6444 -0.878149 -7.94907 +580 4 42.7371 3.8089 1.73084 7.8177 -0.664582 -10.9353 +581 4 43.3892 2.25631 1.16493 5.07933 -5.28874 -15.8541 +582 1 44.0858 40.4147 5.76991 -7.82686 10.7063 0.0613705 +583 2 44.6952 39.2248 6.26612 46.8291 -49.1328 2.55503 +584 2 45.6273 38.4983 5.15014 -10.8203 -24.5871 -10.3389 +585 3 45.1671 38.1033 4.04814 1.93862 22.6196 32.2907 +586 4 45.3114 39.4262 7.20071 -5.62912 7.00222 -16.0196 +587 2 43.5561 38.2867 6.74046 -22.632 -0.869913 -14.9675 +588 2 42.367 38.8131 5.80069 8.99216 14.1028 58.1483 +589 2 42.6345 40.3137 5.92605 0.476166 33.3948 28.8915 +590 4 43.357 38.4284 7.8368 -6.62566 13.9326 -12.0425 +591 4 43.8048 37.1922 6.7609 -3.60965 9.48681 -21.6917 +592 4 41.3136 38.6254 6.13023 8.266 -9.51845 1.65532 +593 4 42.4187 38.6156 4.74928 6.70678 -23.3061 -29.6074 +594 4 42.2773 40.816 6.98347 15.1971 -23.3227 -46.4987 +595 4 42.1119 40.8277 5.08767 -3.55372 4.4917 2.49103 +596 1 46.8487 37.9967 5.55394 17.2019 12.2692 25.006 +597 2 47.7247 37.0178 4.87762 -6.21972 -16.2302 -28.9734 +598 2 47.0354 35.8358 4.10675 -5.54108 30.4574 49.2069 +599 3 47.4638 35.4602 3.01706 -3.2731 6.26074 0.626287 +600 4 48.411 37.4477 4.12082 -11.0175 18.1135 -5.68521 +601 2 48.6499 36.5231 5.98749 -16.6595 -15.0747 15.7963 +602 2 48.891 37.7945 6.79307 0.637735 -25.9659 35.4869 +603 2 47.512 38.4108 6.81936 -6.06228 0.364124 -35.7901 +604 4 49.55 36.0027 5.64818 14.2665 0.926908 -8.4052 +605 4 48.1323 35.7432 6.6035 -1.04051 5.39171 0.916503 +606 4 49.6303 38.4539 6.33816 11.9938 9.28906 -4.17289 +607 4 49.2156 37.5316 7.87598 -0.828426 8.45001 -24.626 +608 4 47.6223 39.5002 6.92189 -5.61966 10.135 -2.25063 +609 4 46.9349 38.0418 7.65693 -11.0214 -6.34351 22.8142 +610 1 45.9811 35.3016 4.79343 19.1712 31.3513 11.165 +611 2 45.3118 34.1769 4.28537 -21.2148 -46.3229 -17.5718 +612 2 44.4751 34.4561 3.06273 -18.3812 8.00009 -33.6438 +613 3 44.391 33.6426 2.09905 3.94034 16.0457 30.0851 +614 4 45.6176 35.6832 5.71813 13.2063 -8.66839 -22.6288 +615 4 46.0373 33.4799 3.80083 11.0255 -0.404913 12.3267 +616 2 44.604 33.4055 5.40679 37.9095 -5.49339 -20.8443 +617 2 43.894 32.1911 4.95963 4.52806 -52.0805 -10.2655 +618 3 42.6666 32.0496 5.30411 26.1406 -7.63566 -17.5185 +619 3 44.6473 31.2926 4.419 -30.7677 19.4747 14.2469 +620 4 43.8381 33.9821 5.82617 -35.1808 40.951 30.2942 +621 4 45.3664 33.1691 6.19311 -10.275 -1.0365 4.4818 +622 1 43.9409 35.7078 2.94042 3.22733 -51.5357 -49.9186 +623 2 43.348 36.2006 1.70588 25.8776 -9.12573 -18.8138 +624 2 44.3757 36.8172 0.713167 -7.64912 -13.2689 38.6134 +625 3 44.0628 36.9589 41.4508 -2.41529 3.02373 -15.0868 +626 4 43.9087 36.323 3.69682 4.46748 41.5024 48.5675 +627 4 43.0059 35.3045 1.0879 -7.34341 13.0696 15.3539 +628 2 42.2218 37.2049 1.98307 -32.8685 -0.904888 11.5727 +629 2 41.1062 36.5938 2.90711 22.5622 20.6064 -2.77479 +630 2 39.8757 37.4913 2.92488 9.99264 -5.47282 62.3883 +631 3 39.5847 37.9927 4.02645 -6.88693 1.84466 -13.34 +632 1 39.0832 37.5519 1.86835 -2.09978 -20.426 -31.5908 +633 4 41.7044 37.4782 1.02484 10.2081 4.13789 1.30545 +634 4 42.5649 38.1527 2.49808 3.34998 -7.04672 -12.996 +635 4 41.496 36.4873 3.97615 -8.32458 2.86238 -16.0656 +636 4 40.817 35.592 2.59085 -6.50381 -15.3028 -7.15704 +637 4 39.3467 37.1489 0.943045 -1.18671 2.30285 11.2704 +638 4 38.1024 37.7997 2.00291 -4.61511 13.1634 -1.5169 +639 1 45.5865 37.1913 1.18701 0.34656 3.48246 -50.9957 +640 2 46.5715 37.7193 0.263736 40.0587 13.4866 27.3297 +641 2 47.1476 36.6709 41.2495 -9.99518 -39.8037 -22.9547 +642 3 47.6611 35.6473 41.7682 -3.12622 19.3551 -24.5438 +643 4 45.9505 37.0475 2.10099 0.0710674 -6.02767 36.3056 +644 4 46.0766 38.4733 41.5789 -9.05589 19.6465 -18.4972 +645 2 47.8462 38.4064 1.04164 -24.5048 14.2529 -26.5929 +646 2 47.4036 39.6651 1.82888 -3.7708 6.53308 31.1421 +647 2 48.5926 40.4064 2.51341 13.2626 3.99863 -2.76696 +648 3 49.7104 40.5691 1.98441 -24.6046 -10.5895 -1.86534 +649 1 48.3407 40.8898 3.74779 29.4138 -3.81739 16.8938 +650 4 48.597 38.7482 0.246377 -8.81496 -5.86425 14.2737 +651 4 48.3893 37.7509 1.72975 1.66752 -15.4435 3.74234 +652 4 46.6019 39.4971 2.66308 23.3117 -7.11271 -27.0857 +653 4 46.9261 40.3559 1.12913 -3.21242 13.4997 -7.95635 +654 4 47.3907 40.9351 4.12169 -5.60594 2.69026 7.41827 +655 4 49.1659 41.1473 4.37984 -25.8317 -2.18268 -20.985 +656 1 47.0143 36.8241 39.8589 2.94896 -6.17569 33.9376 +657 2 47.6738 36.0506 38.8108 16.6825 -23.5637 34.6067 +658 2 48.454 37.0258 37.9695 9.24498 -19.2444 17.2828 +659 3 47.9734 37.5867 37.0249 -16.9661 22.5794 -32.933 +660 4 46.3407 37.4883 39.4677 -2.13376 9.43233 0.449621 +661 4 48.4374 35.3321 39.3605 -24.6855 17.1776 -23.0678 +662 2 46.6968 35.2528 37.909 -27.9143 -33.2437 25.7199 +663 2 46.039 33.9895 38.7043 9.93401 10.5983 7.56799 +664 2 46.87 32.6784 38.9289 23.0786 -0.450758 -24.5995 +665 1 47.7656 32.5928 40.0651 -0.0346617 67.7235 50.2506 +666 2 48.5337 31.5574 40.3699 -14.5633 -26.8579 -35.9878 +667 1 48.7282 30.552 39.4879 -2.05986 8.25564 18.106 +668 1 48.8872 31.3858 41.6213 -4.84512 27.348 -3.11289 +669 4 47.2327 34.8627 37.0058 -5.81127 5.13112 -1.60937 +670 4 45.8267 35.9464 37.6192 18.3744 -10.9215 -5.83414 +671 4 45.065 33.6697 38.178 15.3305 12.1509 10.6411 +672 4 45.8045 34.3704 39.7428 -14.1926 -3.74807 -10.9265 +673 4 47.5159 32.4832 38.0006 -21.4463 1.51143 8.96621 +674 4 46.1858 31.8178 39.0967 -9.12823 -0.449275 -15.1225 +675 4 47.7485 33.3794 40.8208 -8.02877 -26.8637 -33.9869 +676 4 48.3609 30.5297 38.5261 -2.43008 2.66571 1.08755 +677 4 49.1746 29.6933 39.8011 5.57148 -11.3344 1.43527 +678 4 48.5595 32.0107 0.447997 -4.49593 6.14729 8.57279 +679 4 49.3675 30.5632 41.8859 20.5825 -37.41 17.1512 +680 1 49.6971 37.2567 38.3612 38.8031 36.8466 -19.9315 +681 2 50.6251 38.1764 37.6375 5.59701 -6.58181 11.8605 +682 2 51.1059 37.476 36.33 -5.39593 -3.52342 3.95062 +683 3 51.4567 36.2851 36.3473 -6.1727 9.88097 2.62067 +684 4 50.1666 36.6257 38.9842 10.5469 -17.0261 18.2142 +685 4 50.0436 39.1015 37.4003 1.48542 -2.85918 -9.88003 +686 2 51.8783 38.6033 38.5414 -14.1699 17.2606 4.5582 +687 2 51.4771 39.4948 39.8067 23.634 -8.13025 9.13717 +688 2 52.8025 39.6936 40.6861 -45.72 0.0787629 30.9804 +689 2 51.0312 40.8873 39.3543 -1.21924 6.71403 17.5275 +690 4 52.6247 39.2003 37.9187 -12.0326 -10.2321 5.24388 +691 4 52.4336 37.7304 38.9418 -1.83231 -8.6555 -7.07863 +692 4 50.6844 38.9864 40.4458 6.67436 6.37453 -9.78056 +693 4 52.9275 38.7652 41.2899 1.57503 4.15297 5.5095 +694 4 52.875 40.6185 41.4124 -9.95772 -27.9304 -22.9777 +695 4 53.6477 39.6981 40.0479 39.2622 9.27083 -23.1198 +696 4 51.882 41.4315 38.8764 -8.78739 -1.58992 -12.4168 +697 4 50.8284 41.5065 40.2813 -10.0843 -5.65437 -12.2377 +698 4 50.1041 40.7893 38.7156 9.84678 12.7352 4.22225 +699 1 51.1335 38.2092 35.1872 23.4477 43.7196 -18.1994 +700 2 51.5372 37.7272 33.8205 5.66277 23.826 53.2621 +701 2 52.816 38.5373 33.39 -13.9696 27.2523 3.91394 +702 3 52.9014 39.7954 33.5824 -9.48934 -35.8428 -1.88315 +703 4 51.0917 39.2914 35.1751 -6.07189 -44.7564 8.7296 +704 4 51.807 36.6734 33.9114 3.67702 -17.8942 -3.77347 +705 2 50.2728 37.942 32.9627 24.5619 2.20768 -27.072 +706 2 49.0946 37.0552 33.3907 -40.4332 32.861 4.12747 +707 2 50.6582 37.6771 31.4819 -4.87136 -12.6088 -15.1928 +708 2 49.1924 35.592 33.2496 18.605 -47.1891 -10.6734 +709 4 50.0222 39.0181 33.0462 -10.0421 3.96713 0.824793 +710 4 48.1822 37.369 32.7965 11.3859 0.507389 5.43773 +711 4 48.766 37.227 34.4352 6.35082 10.8857 5.72377 +712 4 49.7261 37.457 30.8365 21.3715 9.42576 10.5226 +713 4 51.3528 36.7896 31.3856 -11.4398 6.26312 1.5823 +714 4 51.2274 38.5516 31.0485 -10.0605 -6.0953 1.35419 +715 4 50.1827 35.2313 33.6939 -19.2762 -1.86106 -7.31237 +716 4 49.1345 35.3223 32.1629 6.46074 -3.78635 4.92713 +717 4 48.3248 35.0641 33.7333 8.66481 1.90115 0.669024 +718 1 53.7674 37.8522 32.7049 -0.401058 29.0536 2.76503 +719 2 54.8534 38.494 31.9889 21.3589 25.2573 -50.7784 +720 2 0.070256 37.9331 30.5159 -12.6617 -10.513 26.1463 +721 3 0.610536 36.8336 30.3273 -13.153 9.14635 -3.0322 +722 4 53.7049 36.8532 32.6778 5.78014 -33.2974 -6.55066 +723 4 54.4976 39.583 31.7137 12.734 -24.0185 30.659 +724 2 1.32523 38.4582 32.6174 -11.2306 -14.0383 43.8112 +725 2 2.25298 39.4244 31.93 21.239 -3.52493 -6.53852 +726 2 1.82142 40.7594 31.946 9.01925 8.15494 1.3639 +727 2 3.55305 39.1373 31.3858 -52.1121 -37.4601 32.7366 +728 2 2.62719 41.7738 31.436 16.1375 42.966 -9.20235 +729 2 4.2717 40.1621 30.8907 55.019 31.5071 -38.7093 +730 2 3.8753 41.5182 30.8618 10.3374 -30.1635 6.5347 +731 4 1.72137 37.3957 32.6071 -2.968 13.2806 -7.3675 +732 4 1.36361 38.7573 33.7485 -10.0277 -6.08615 -32.1159 +733 4 0.900203 41.04 32.4671 -4.90014 4.47018 0.827909 +734 4 4.05865 38.1292 31.3848 -19.507 10.3261 2.47632 +735 4 2.40669 0.963664 31.507 -12.4107 -17.8541 2.52862 +736 4 5.22734 39.8163 30.4261 -2.17835 18.3508 4.41679 +737 4 4.61313 0.382875 30.4956 -18.9116 -9.53382 4.9162 +738 1 54.5208 38.7001 29.536 -17.794 9.59417 2.44526 +739 2 54.4433 38.3677 28.0932 0.413701 6.77287 11.8816 +740 2 53.8236 36.9714 27.8054 -10.5704 38.9519 24.3324 +741 3 54.2836 36.1684 27.0139 12.3723 -16.7122 -9.38408 +742 4 54.0063 39.582 29.8758 15.9225 -27.1932 -25.0825 +743 4 53.6617 39.0994 27.7122 21.1252 -9.31914 -10.5745 +744 2 0.84771 38.4562 27.3872 5.21129 26.4327 0.415045 +745 4 1.55752 39.2926 27.6564 -22.375 -0.429945 3.27523 +746 4 0.737328 38.5366 26.268 -0.662808 -7.52676 8.67249 +747 4 1.44048 37.5755 27.6711 3.3074 -14.1434 -6.0421 +748 1 52.6712 36.7812 28.4639 -34.4859 10.4254 42.9936 +749 2 51.8461 35.5981 28.5315 7.11639 -32.3641 19.2856 +750 2 52.1287 34.6607 29.761 72.1729 37.4894 -16.6197 +751 3 51.2969 33.8912 30.1393 -37.38 -39.1809 16.7772 +752 4 52.2301 37.5459 29.0797 18.7619 -22.9106 -24.882 +753 4 50.752 35.8045 28.6381 6.6344 10.4547 -3.03351 +754 4 51.9318 34.9661 27.6028 3.27123 7.03186 8.45077 +755 1 53.4041 34.6064 30.3039 -37.1524 -18.2668 23.7743 +756 2 53.8481 33.579 31.3343 19.9058 12.4048 -28.9308 +757 2 53.2753 33.7631 32.7245 -4.20442 17.2631 -10.7202 +758 3 53.3264 34.8931 33.2388 -7.00143 -11.8952 2.65621 +759 4 53.9984 35.4233 30.2821 14.046 11.4873 -9.55867 +760 4 53.5575 32.5679 30.9796 -2.97426 -3.20006 -4.3618 +761 2 0.441949 33.6673 31.397 15.483 24.485 -22.5221 +762 2 1.1159 33.1056 30.111 -2.52249 -22.0361 -11.2405 +763 2 2.65939 33.3504 30.0471 -29.7948 -11.8394 -36.8606 +764 2 3.5253 32.433 30.8659 3.71436 3.74322 35.9681 +765 1 4.92891 32.7835 30.8601 -3.73949 -14.6782 3.94495 +766 4 0.930008 33.1164 32.2052 -10.1795 -8.12889 21.2637 +767 4 0.820281 34.7554 31.5264 -17.1946 -20.5931 1.67355 +768 4 0.726808 33.5631 29.1693 -8.69229 5.5421 6.41341 +769 4 0.816642 32.0044 30.0112 14.0154 14.8269 0.94841 +770 4 2.76655 34.4177 30.2798 16.9839 11.3836 1.64388 +771 4 2.99027 33.2006 28.9712 -4.31169 8.16855 10.4317 +772 4 3.48024 31.3628 30.6286 -9.21502 -9.13385 -9.88849 +773 4 3.14214 32.5157 31.9169 10.307 -3.37241 -3.01155 +774 4 5.38024 32.7641 29.968 4.13535 -6.65161 -12.8027 +775 4 5.44585 32.16 31.4735 7.57437 4.94374 1.68638 +776 4 5.11721 33.7072 31.1652 -0.520286 24.3887 13.7994 +777 1 52.7286 32.6609 33.3217 21.3895 7.82715 -40.48 +778 2 52.3746 32.6765 34.6845 -3.94215 -5.7204 42.1903 +779 2 53.6544 32.9612 35.4718 -32.0777 16.7216 -3.31611 +780 3 54.7101 32.4293 35.2196 26.5529 -12.799 -1.69002 +781 4 52.7346 31.7402 32.8358 -3.66087 10.5856 2.03104 +782 4 51.6553 33.4893 34.886 -4.93781 11.2662 -7.45083 +783 2 51.7389 31.3462 35.1425 36.1525 -8.24878 -2.45066 +784 2 50.4549 31.4357 35.902 -2.56298 9.46411 57.003 +785 2 50.5914 31.9702 37.3969 -4.77582 -10.2539 -35.2763 +786 3 49.9129 32.941 37.7385 4.53321 10.1718 7.36032 +787 1 51.4448 31.3274 38.2318 1.89331 10.2207 20.9211 +788 4 52.4532 30.7011 35.7138 0.934865 4.72627 -2.3237 +789 4 51.5619 30.7887 34.2312 -11.1921 -21.1455 -14.7508 +790 4 50.0197 30.4197 36.0127 -8.03636 -0.273264 -6.56567 +791 4 49.7685 32.1089 35.3545 -11.9583 -2.57651 0.31815 +792 4 51.7323 30.3416 38.1022 2.22495 5.18328 -8.30147 +793 4 51.645 31.7871 39.1631 -4.2657 -12.8631 -21.1898 +794 1 53.54 33.8952 36.4131 -39.2018 -0.531466 -0.79929 +795 2 54.5682 34.2648 37.3102 -29.3437 58.7358 21.9421 +796 2 54.3255 33.5954 38.6431 29.6978 -77.406 0.637438 +797 3 53.3742 33.7807 39.3881 -15.8118 22.9548 5.85491 +798 4 52.6165 34.3686 36.5483 14.9252 -1.63515 2.31459 +799 4 0.525104 33.9954 36.8979 32.3496 -27.0675 -4.05845 +800 2 54.6285 35.827 37.4074 -17.7645 -17.3983 39.0191 +801 2 0.013954 36.4546 36.058 15.6745 -1.04323 18.583 +802 2 0.049019 37.9526 36.293 -63.1087 6.90888 -39.4544 +803 2 1.42802 35.9308 35.6826 4.08802 -6.56861 34.108 +804 4 0.435555 35.9801 38.2063 -13.4425 16.5914 -13.2273 +805 4 53.6198 36.2963 37.798 28.292 -21.2068 -7.80607 +806 4 54.2061 36.2134 35.3084 7.36084 -1.04605 -3.46995 +807 4 54.0713 38.2397 36.8522 27.1057 4.55429 -9.55418 +808 4 54.939 38.4282 35.2643 6.0019 1.58695 18.2366 +809 4 0.927863 38.3313 36.762 28.685 14.2218 21.5028 +810 4 1.30489 34.8989 35.3991 1.43296 -22.664 -21.4406 +811 4 2.25694 35.8344 36.4845 -24.5016 17.8738 -12.6534 +812 4 1.83634 36.4362 34.8335 13.635 15.7788 -26.8996 +813 1 0.008587 32.3758 38.733 13.7846 27.3237 -75.0314 +814 2 54.826 31.3 39.6331 17.4428 -14.6066 45.4768 +815 2 0.455793 31.7866 40.9725 -5.37526 1.66294 14.9859 +816 3 1.60943 32.1773 41.0547 11.2247 3.92934 -7.13086 +817 4 0.661532 32.0877 37.9163 -19.8505 19.9989 33.4434 +818 4 53.7452 31.1425 39.875 0.374502 -5.35979 -15.722 +819 2 0.574437 30.0043 39.0439 11.2157 23.6116 11.9724 +820 2 0.334302 28.7136 39.8578 -22.6665 -11.1233 -21.4622 +821 2 0.695999 28.7 41.3625 12.0844 -36.9796 9.0265 +822 3 54.7253 28.727 0.298109 10.889 15.3071 -4.11946 +823 3 1.91063 28.4506 41.7261 -30.7481 15.8042 -10.4483 +824 4 1.71086 30.1341 39.082 -19.7243 9.32222 0.312381 +825 4 0.358791 29.9926 37.9166 -2.62684 -19.8589 21.79 +826 4 0.882365 27.912 39.2891 -0.232785 0.308618 14.1734 +827 4 54.2301 28.3798 39.7718 17.2545 10.1943 -0.206185 +828 1 54.6325 31.7916 0.156881 38.5875 2.07504 -29.8841 +829 2 54.8631 32.3302 1.45975 7.41407 33.4343 26.7616 +830 2 1.21087 32.0241 2.20189 -33.1211 2.89979 -4.9396 +831 3 1.57835 32.811 3.08735 12.0797 -3.2377 -11.0832 +832 4 53.6756 31.6317 41.8616 -38.5912 -7.03962 0.740029 +833 4 54.9627 33.4927 1.3754 -11.7864 -35.033 -4.32612 +834 2 53.6666 32.0355 2.42828 -17.6969 8.95863 -1.18459 +835 2 52.1933 32.3158 2.0402 15.1012 41.0915 -15.9482 +836 3 51.3911 33.0513 2.74715 36.5037 -34.5123 -13.5772 +837 3 51.9207 32.0348 0.835441 -22.1157 -3.97518 6.29873 +838 4 53.9089 32.5595 3.33158 -2.01457 20.6007 30.7692 +839 4 53.6609 31.0051 2.75768 6.68313 -26.6133 3.27231 +840 1 1.77413 30.8239 1.99288 23.346 -11.0551 12.4557 +841 2 2.99412 30.3649 2.70859 20.7873 20.7026 2.58588 +842 2 4.37767 30.5585 1.9432 -4.58172 12.4342 76.2013 +843 3 5.43315 30.6356 2.6242 -17.4542 -1.84538 -14.1099 +844 4 1.23141 30.1158 1.49013 8.16278 -4.42375 -5.05013 +845 4 3.08709 30.9756 3.71749 -2.54673 -19.312 -31.0286 +846 4 2.99418 29.2776 2.99437 -11.6108 14.2547 -3.21828 +847 1 4.33484 30.73 0.643592 -44.4777 10.1896 -41.2897 +848 2 5.29878 31.2923 41.6537 25.3276 0.744315 3.96016 +849 2 5.54544 32.7486 0.121481 37.2819 -30.872 -27.7426 +850 3 4.68176 33.387 0.67546 -18.5336 28.2868 17.8008 +851 4 3.3891 30.7154 0.224796 5.58966 -1.49205 -0.51948 +852 4 6.30256 30.8588 41.8823 -3.47112 -15.4387 -8.82901 +853 2 4.8423 31.1802 40.1578 47.5835 -21.6785 -9.15502 +854 2 4.71332 29.7742 39.4637 -7.18766 34.2596 -8.85866 +855 2 5.63064 28.6968 40.0034 1.34917 -52.5839 -25.1875 +856 1 5.28494 28.1736 41.3081 -3.70672 3.58414 23.7744 +857 2 6.07557 28.0057 0.492928 -10.4577 4.69864 -29.3733 +858 1 7.37832 28.2278 0.392183 22.9004 -4.79637 26.256 +859 1 5.53705 27.6868 1.66636 -6.4094 -24.443 39.9026 +860 4 5.53303 31.787 39.5095 -0.196101 -2.7377 7.98036 +861 4 3.92152 31.7024 40.0755 -40.4143 20.5365 -6.7059 +862 4 4.89215 29.8961 38.3273 -2.53464 -0.592337 23.8175 +863 4 3.64677 29.4833 39.5295 -2.27017 -8.63927 2.61329 +864 4 6.69627 28.939 39.9328 9.42975 10.3347 -2.35439 +865 4 5.48992 27.7969 39.2806 7.04825 21.6687 20.0754 +866 4 4.27254 28.0467 41.4152 -4.83075 -3.28587 3.65899 +867 4 7.98538 28.2099 41.4852 -8.02405 3.18538 -21.0185 +868 4 7.94047 28.2423 1.24565 0.364194 -0.98827 11.7246 +869 4 4.53186 27.4078 1.78766 14.7644 10.3007 -8.4097 +870 4 6.1013 27.52 2.55737 -8.44391 7.70178 -27.0297 +871 1 6.79596 33.2006 41.6804 -27.9344 8.59735 4.57792 +872 2 7.15148 34.5952 41.8655 -38.9276 -12.1291 -1.68573 +873 2 6.77215 35.2911 40.5652 14.0197 56.9428 51.8707 +874 3 6.49158 34.715 39.5569 -13.5951 -21.5425 -43.0675 +875 4 7.31858 32.7386 40.9072 -2.655 4.76346 14.1821 +876 4 6.52583 35.0505 0.829338 19.3934 -10.3795 -24.0216 +877 2 8.63545 34.7883 0.159249 -4.7809 22.3707 74.7553 +878 3 9.31911 34.1951 41.0459 32.4158 -10.9375 -20.7672 +879 2 9.12239 34.1481 1.54228 -45.3508 12.3646 -39.5443 +880 4 8.86138 35.9031 0.177513 1.59938 -13.4643 1.18346 +881 4 10.1943 34.4871 41.2598 15.0836 -7.29109 -20.5697 +882 4 10.1218 34.4779 1.7295 32.9793 8.82002 13.7556 +883 4 9.1354 33.0404 1.45915 -3.89828 -1.77159 7.54964 +884 4 8.44695 34.5279 2.36236 9.39315 -9.78399 0.0431608 +885 1 6.96309 36.6454 40.6555 -22.2962 -38.3404 -33.8498 +886 2 6.94214 37.5275 39.5132 -15.3576 22.9899 27.1878 +887 2 8.03225 37.1821 38.5547 25.8315 2.87875 -39.3086 +888 3 7.87409 37.2091 37.3037 -11.7489 -2.94068 30.2829 +889 4 7.09017 37.0079 41.5812 4.58243 22.402 24.7274 +890 4 6.01646 37.4072 38.9238 -6.0018 -8.28766 -1.15408 +891 2 7.01182 39.0163 40.0252 -15.3603 -23.3284 55.3652 +892 2 5.61926 39.5384 40.7634 13.0639 11.727 -14.3013 +893 2 5.74741 41.0778 41.0735 34.612 -8.65688 -61.1535 +894 2 4.30485 39.278 39.9775 33.2171 6.29002 -24.4772 +895 4 7.23253 39.6079 39.1676 9.01238 29.648 -28.6912 +896 4 7.91826 39.1206 40.7867 -28.368 0.120823 -25.2036 +897 4 5.4532 38.9933 41.7239 13.5286 -1.18368 4.70417 +898 4 4.88701 41.4539 41.5866 -22.2749 9.39049 21.0562 +899 4 5.89633 41.7578 40.1185 -8.19165 -26.548 25.276 +900 4 6.67066 41.2365 41.6556 -0.494064 4.57358 11.7906 +901 4 4.18164 39.8273 38.9933 8.48456 -7.17755 11.4037 +902 4 3.44244 39.5261 40.5797 -17.807 1.17877 7.97341 +903 4 4.2824 38.1939 39.7929 -10.4691 -3.8299 -8.01616 +904 1 9.23783 36.8543 39.0653 -4.40645 21.0053 19.4908 +905 2 10.3275 36.5838 38.1582 31.0816 -25.3995 62.8998 +906 2 10.2997 35.2224 37.4613 6.04581 38.1949 -0.210763 +907 3 11.0208 35.1071 36.4655 -6.3656 -14.3958 -11.0193 +908 4 9.51333 37.1441 40.0706 -14.9717 -14.5173 -38.8343 +909 4 10.386 37.3498 37.3821 -1.67567 12.3369 -13.0834 +910 2 11.6168 36.6846 39.0604 -5.3878 -32.5356 -23.0633 +911 3 11.6818 35.7254 40.0985 -18.2206 13.507 16.8431 +912 4 11.7318 37.6647 39.5052 6.99822 20.9023 2.76215 +913 4 12.4798 36.426 38.4299 12.1644 16.7594 -11.1747 +914 4 12.2479 35.0511 39.7675 10.0745 -20.8981 -3.76732 +915 1 9.3909 34.3264 37.8733 -42.427 -15.3638 26.6935 +916 2 8.99216 33.1557 37.0842 54.1918 17.4661 1.85655 +917 2 8.44195 33.5842 35.7305 -20.833 60.571 55.2199 +918 3 8.45395 32.8337 34.8033 7.91235 -41.3122 -40.5547 +919 4 8.901 34.4208 38.8182 18.72 -3.57692 -25.7233 +920 4 10.0039 32.69 36.8915 -15.1884 -12.4868 -9.34361 +921 2 8.05349 32.1507 37.7268 -1.844 -26.1592 7.76215 +922 2 8.63612 31.2276 38.7905 8.98886 15.2457 3.52798 +923 3 8.28567 31.4376 39.9878 9.18033 -14.5703 -9.08999 +924 3 9.46172 30.3301 38.4185 -14.4281 10.7169 -2.66077 +925 4 7.57008 31.4717 36.9797 -4.32683 11.3708 2.99534 +926 4 7.24557 32.7088 38.1955 -18.7592 7.98312 4.87833 +927 1 7.76821 34.7903 35.7104 -0.921577 -49.5867 -7.77983 +928 2 7.00589 35.2713 34.5947 28.4194 33.7396 -49.4054 +929 2 7.85162 36.3274 33.7967 14.0615 10.3677 50.876 +930 3 7.59561 36.677 32.642 -11.5138 -12.0529 -0.0837023 +931 4 7.64044 35.3156 36.5601 -2.79577 12.0246 16.4277 +932 4 6.95142 34.464 33.8059 -8.74679 1.13416 10.6726 +933 2 5.60472 35.8897 34.9384 -10.82 -34.5279 -29.2679 +934 2 4.80808 34.6511 35.4252 21.4048 19.1212 -24.4535 +935 2 4.58939 34.449 36.7896 -8.79739 7.49237 6.99756 +936 2 4.44707 33.6361 34.4808 -22.1156 13.6667 13.0483 +937 2 3.78406 33.375 37.155 10.056 16.8174 60.0349 +938 2 3.57928 32.5992 34.8543 35.6828 20.067 14.4288 +939 2 3.32606 32.5122 36.2195 -36.4887 -32.5961 -12.2866 +940 3 2.43989 31.6229 36.7148 -5.7594 -17.052 -20.0699 +941 4 5.14192 36.3424 33.9886 5.39246 -18.3577 14.2305 +942 4 5.60606 36.7583 35.5989 7.01287 1.52307 19.367 +943 4 4.94491 35.1783 37.5598 -4.47364 -7.92921 -7.91861 +944 4 4.66046 33.7427 33.4202 4.87397 4.4658 -8.40916 +945 4 3.45738 33.1597 38.2449 15.2806 17.1295 -26.8514 +946 4 3.26795 31.828 34.148 -6.61111 -3.61155 -4.72788 +947 4 2.1868 31.1622 35.9134 -6.91994 -9.03483 11.406 +948 1 8.90205 36.8981 34.5027 -17.2687 17.5401 -60.9896 +949 2 9.70361 38.0134 33.9387 24.2231 -52.0812 37.3823 +950 2 8.8546 39.1711 33.5701 14.7092 18.0593 -4.53516 +951 3 9.06515 39.7643 32.526 6.45085 3.58457 -7.26619 +952 4 9.11675 36.6435 35.4518 3.62665 -3.0608 21.1339 +953 4 10.3861 38.3235 34.818 -10.2978 3.44266 -21.7419 +954 2 10.5787 37.5562 32.7307 -21.6135 -30.8037 4.74181 +955 2 11.6892 38.5091 32.4223 15.379 -13.1594 38.9153 +956 3 11.683 39.1804 31.4042 4.19267 20.0472 -18.4805 +957 1 12.6852 38.53 33.3751 41.3863 26.0224 -13.8263 +958 4 9.85905 37.4261 31.8504 20.0453 2.40541 7.8736 +959 4 11.053 36.5467 32.9319 -7.17885 8.97611 -4.2567 +960 4 12.817 37.8369 34.166 -15.4043 12.1891 -16.4176 +961 4 13.5001 39.2408 33.2564 -39.0039 -25.8302 4.81098 +962 1 7.96197 39.5631 34.4599 -33.9246 23.5433 37.1278 +963 2 7.21007 40.8276 34.5568 -18.3646 -15.2096 -14.7898 +964 2 8.22007 41.896 34.9201 0.758716 14.3361 -6.26955 +965 3 8.97663 41.7874 35.871 13.0919 -8.40756 13.8683 +966 4 7.83943 39.0508 35.3409 8.95409 -9.59767 0.690263 +967 4 6.70734 41.0591 33.5261 17.9743 -2.28149 22.8597 +968 2 6.0301 40.6247 35.6674 21.3841 11.5647 -11.8815 +969 2 4.89974 39.9794 34.8247 17.8968 2.41192 -27.2216 +970 2 5.64567 41.9074 36.4174 -5.31946 16.9228 -22.0167 +971 2 3.85064 39.271 35.6143 -7.9417 -14.8054 48.1955 +972 4 6.41951 40.0018 36.4929 2.02391 -20.04 -2.41117 +973 4 5.36435 39.2019 34.126 -8.73918 7.93575 11.5905 +974 4 4.48342 40.7424 34.1094 -6.00744 -5.42447 8.5897 +975 4 5.00487 41.8434 37.3074 -11.5574 -14.3762 1.01334 +976 4 5.12929 0.689353 35.6946 7.17582 1.37977 8.89479 +977 4 6.56067 0.460605 36.8355 2.18467 8.54142 -3.2903 +978 4 3.23423 39.9796 36.2601 8.91814 -10.815 -11.4927 +979 4 4.38489 38.5352 36.333 -17.3309 14.265 -14.1697 +980 4 3.16246 38.6765 34.9814 -1.3822 0.0882741 -1.23744 +981 1 8.27901 1.09677 34.1745 -17.8694 -35.8502 15.8719 +982 2 9.1495 2.17731 34.4611 25.5007 24.1899 -15.5427 +983 2 8.44305 3.45517 34.8181 7.33507 13.3767 -14.0082 +984 3 7.22584 3.58853 34.5952 14.73 6.44535 13.4701 +985 4 7.64387 1.07834 33.3925 -5.10967 17.8437 -25.4682 +986 4 9.72616 1.98981 35.3795 6.67437 -11.367 8.50474 +987 2 10.1416 2.3939 33.2727 7.80857 1.28792 -5.65283 +988 2 11.1754 1.27875 33.0535 -29.5709 -1.62172 8.74553 +989 2 12.298 1.25902 34.0434 45.8123 -20.4226 -15.8942 +990 3 13.4264 1.60062 33.6211 -9.09849 2.20405 14.6225 +991 1 12.1286 0.499484 35.1615 13.5856 38.0862 1.93866 +992 4 10.7117 3.33658 33.4062 0.0269402 1.80508 0.780117 +993 4 9.62868 2.54332 32.3022 -11.3844 1.67988 3.84081 +994 4 11.6026 1.39089 32.0291 1.1132 -6.32648 1.88738 +995 4 10.6463 0.304077 33.1517 4.80745 -4.48978 -13.057 +996 4 11.1623 0.324257 35.4356 -7.1112 -9.24345 12.7946 +997 4 12.86 0.645961 35.8984 -11.3978 -13.87 -11.7385 +998 1 9.29061 4.442 35.2624 -22.3208 40.9019 24.8252 +999 2 8.81116 5.82611 35.6978 -18.3987 -9.60009 -41.1421 +1000 2 7.90959 6.36535 34.5148 35.1086 -14.4229 -13.6713 +1001 3 8.27789 6.14754 33.3333 -13.6173 9.04219 21.6414 +1002 4 10.326 4.35425 35.3433 -15.5473 -10.8229 -5.10085 +1003 4 8.07437 5.70026 36.5174 9.02025 -1.47766 10.124 +1004 2 9.99583 6.76313 36.1565 -25.1565 20.6308 -28.9867 +1005 2 11.135 6.93617 35.1361 2.62363 -10.5046 6.46017 +1006 2 12.4502 7.42969 35.8581 -25.4448 -27.2564 -27.4451 +1007 2 12.3858 8.85842 36.3442 -55.084 26.5775 24.6628 +1008 1 13.634 9.41318 36.7712 33.8844 -44.8334 11.878 +1009 4 10.2929 6.30703 37.0832 24.0012 -1.96783 25.2264 +1010 4 9.73373 7.84957 36.4159 -14.1304 -26.7275 0.147522 +1011 4 10.8081 7.68154 34.3572 5.16283 -4.02502 4.78839 +1012 4 11.298 5.9636 34.5725 5.23915 16.0099 8.41141 +1013 4 13.159 7.4137 35.035 25.5516 -2.14082 -10.0364 +1014 4 12.8083 6.68649 36.6117 -1.06896 6.08822 -0.205097 +1015 4 11.642 8.94716 37.2538 22.1051 -1.45756 -27.4817 +1016 4 11.9592 9.50431 35.5025 9.97141 -3.64215 15.7788 +1017 4 13.6538 10.3723 37.0555 -8.09423 13.3796 3.79584 +1018 4 14.2885 9.3339 36.0056 2.60625 13.8446 -5.44478 +1019 4 14.0928 8.83644 37.5176 -15.06 24.3666 -13.6607 +1020 1 6.73429 6.959 34.8261 9.36917 -0.537504 -3.37326 +1021 2 5.68914 7.48312 33.9811 -11.6093 0.198368 -29.7566 +1022 2 4.72257 6.43001 33.3633 23.9678 57.8121 29.6097 +1023 3 3.69345 6.80336 32.8731 -41.5354 18.269 -25.9458 +1024 4 6.5403 7.08067 35.8075 -8.4584 6.57489 23.7637 +1025 4 4.95828 8.08289 34.6274 18.5559 -1.63885 -10.0577 +1026 2 6.30301 8.33887 32.7628 1.61604 -0.894199 46.3222 +1027 2 6.96232 9.68302 33.2113 17.5203 -12.0258 -13.4607 +1028 2 6.11334 10.8061 33.8152 -7.60378 12.6352 19.0416 +1029 3 5.31496 11.4419 33.0422 10.0378 -5.26853 5.86857 +1030 3 6.28181 11.1536 35.05 3.36103 -18.7342 -31.8229 +1031 4 5.5011 8.60814 32.0808 -13.4162 -1.3456 -15.0867 +1032 4 7.01778 7.64283 32.2215 -8.51236 18.4517 -1.11608 +1033 4 7.483 10.1113 32.3225 -5.01151 2.49106 -4.14977 +1034 4 7.84021 9.44334 33.8428 -3.17944 -2.15711 8.7111 +1035 1 4.98957 5.17145 33.408 31.7294 -73.5208 5.3031 +1036 2 4.03057 4.12888 32.9492 20.6717 -14.7005 -20.2168 +1037 2 2.6598 4.36206 33.592 -3.0444 -3.65398 -36.823 +1038 3 2.63368 4.6245 34.7729 -17.9957 9.5377 28.5993 +1039 4 5.93287 4.88555 33.7778 -25.4301 -4.21673 -10.3446 +1040 4 3.97065 4.08898 31.7849 -0.621936 10.7688 28.6704 +1041 2 4.54797 2.73693 33.4323 -9.78314 13.2989 35.3654 +1042 3 5.7396 2.38581 32.8061 3.87836 -1.00687 -28.9834 +1043 4 3.83029 1.94659 33.1597 -9.96533 -6.0451 7.8725 +1044 4 4.7579 2.77573 34.5879 -14.8326 -6.64015 -28.538 +1045 4 6.39905 2.57303 33.4496 16.1931 5.10903 8.49462 +1046 1 1.55493 4.20465 32.7937 9.73391 7.12296 -2.26043 +1047 2 0.143907 4.28394 33.2313 13.768 -18.1657 13.0528 +1048 2 54.6863 2.83094 33.3214 -0.0746788 -18.1404 42.9803 +1049 3 54.7972 2.04898 32.3833 -5.36381 -6.57018 -20.4337 +1050 4 1.75536 3.84626 31.8337 -17.5999 5.97734 12.9737 +1051 4 0.145346 4.72929 34.2869 -5.52407 -1.41906 -16.7638 +1052 2 54.0936 4.99047 32.3072 48.5491 53.4262 27.9832 +1053 3 54.4431 6.39026 32.3568 26.5828 -36.1107 8.98461 +1054 2 52.7233 5.01429 32.8691 -55.1486 3.23885 2.70228 +1055 4 54.1505 4.66496 31.2868 0.0550865 -16.0071 -29.7017 +1056 4 53.7986 6.85268 31.88 -20.6445 25.8891 -20.893 +1057 4 52.6197 5.54793 33.8322 5.93951 -5.3567 9.34144 +1058 4 52.3467 3.98503 32.9647 -9.06602 -5.34833 4.63236 +1059 4 51.9747 5.55452 32.2255 9.49609 -7.51028 -3.22615 +1060 1 54.1802 2.39741 34.5222 -14.8232 32.9081 27.5353 +1061 2 53.4465 1.14651 34.785 33.9277 15.1 -62.0226 +1062 2 52 1.44639 34.4384 -40.9452 -8.29472 -14.3346 +1063 3 51.516 2.52365 34.8247 -1.26544 -9.47139 -8.9244 +1064 4 54.0715 3.07846 35.3501 9.6448 -17.4772 -31.2652 +1065 4 53.9076 0.391021 34.1043 -10.2836 -7.20705 -0.475865 +1066 2 53.6069 0.737389 36.2058 40.6624 3.41232 47.0409 +1067 2 0.15698 0.778637 36.8849 -22.9225 14.5477 7.59965 +1068 2 0.184063 0.045177 38.2545 -1.48959 -18.0819 6.68284 +1069 2 1.19764 0.213126 35.924 -17.0247 17.4527 -16.4279 +1070 4 53.1759 41.6554 36.3315 -4.28574 -19.6707 2.88188 +1071 4 52.9166 1.40322 36.7387 0.80484 4.57892 22.2756 +1072 4 0.570353 1.84035 37.1024 -27.1105 -11.6335 -5.02718 +1073 4 54.3756 0.329349 38.9832 1.77724 8.98271 -8.45905 +1074 4 1.16626 0.241414 38.7954 -11.8595 -7.79047 -8.4361 +1075 4 0.0237 40.841 38.1265 8.8292 11.305 -0.869273 +1076 4 2.1582 0.044818 36.439 11.171 3.86438 -4.7836 +1077 4 1.22244 1.0066 35.1406 25.1303 -1.4606 -0.0516333 +1078 4 0.965216 41.2564 35.3038 -8.75588 -20.9773 6.66787 +1079 1 51.2089 0.49816 33.7614 57.6433 8.13256 28.0245 +1080 2 49.794 0.627079 33.5149 3.58551 37.6409 23.5907 +1081 2 49.1504 41.7362 34.5845 -39.3958 -31.0429 53.6988 +1082 3 49.3072 40.5133 34.7023 12.9245 12.8492 -11.6005 +1083 4 51.5663 41.4343 33.8516 -6.054 3.49016 -14.1934 +1084 4 49.5236 1.72635 33.6347 -1.89472 -11.9516 -1.26615 +1085 2 49.2899 0.093076 32.2111 -20.0469 10.239 -57.1496 +1086 2 49.5504 1.0758 31.0546 44.1484 5.96661 -35.419 +1087 1 48.7105 2.02971 30.4517 -2.34523 -25.3315 39.2373 +1088 2 50.7977 1.22066 30.3277 -75.7848 7.88288 4.96893 +1089 2 49.299 2.59293 29.3763 -23.865 8.39496 11.0232 +1090 1 50.5677 2.14293 29.3127 -12.36 -15.4034 27.3398 +1091 4 48.1533 41.8436 32.187 18.4481 1.21563 9.00361 +1092 4 49.725 40.9798 32.0543 -2.35302 7.24771 -7.56512 +1093 4 47.7373 2.26457 30.8018 19.6426 -7.09987 -8.69392 +1094 4 51.6402 0.582035 30.3922 15.3203 -1.97636 0.19948 +1095 4 48.6832 3.25559 28.7541 24.649 -5.28154 -1.94766 +1096 4 51.2124 2.39582 28.5799 18.4236 6.97779 -14.3308 +1097 1 48.3633 0.438016 35.503 -1.69139 30.1001 11.6909 +1098 2 47.6687 41.7006 36.6492 0.613805 18.6924 -40.9612 +1099 2 46.264 41.3694 36.1307 -7.02361 -30.4834 5.87484 +1100 3 45.3463 0.246853 35.8895 18.8914 5.06283 8.3795 +1101 4 48.1281 1.45816 35.4039 5.5506 -16.4063 -0.101422 +1102 4 48.2062 40.7837 36.9784 6.36967 -2.21031 -8.42979 +1103 2 47.5958 0.687745 37.8565 -25.4558 59.2473 29.5222 +1104 2 46.6931 0.064749 39.0402 -2.78345 4.00632 18.8053 +1105 2 47.0383 40.4557 39.4221 -33.2538 18.6268 -20.4936 +1106 2 46.93 0.927044 40.3419 31.4794 -11.2994 1.29194 +1107 4 47.1354 1.76149 37.5629 9.48386 -42.5729 7.15928 +1108 4 48.6298 0.997945 38.2155 -14.6806 -19.3715 -2.98409 +1109 4 45.5391 0.148422 38.8474 30.3772 -4.98305 -7.99897 +1110 4 47.9695 40.2725 39.9165 32.6255 3.33763 11.188 +1111 4 46.9967 39.7545 38.5575 0.158611 5.44488 0.559019 +1112 4 46.2719 40.0836 40.1333 -2.82757 0.291607 -0.331179 +1113 4 48.0832 1.04093 40.5802 -35.3824 -1.71169 -8.39188 +1114 4 46.4823 0.388091 41.2333 0.118939 13.4124 -7.57083 +1115 4 46.4764 1.95182 40.2253 3.79994 -8.06745 5.67231 +1116 1 46.1155 40.0363 35.9994 32.2071 3.49142 -20.6914 +1117 2 44.9353 39.2817 35.7114 0.014229 -40.6503 61.2515 +1118 2 44.4179 38.8949 37.157 4.06758 -27.6469 18.473 +1119 3 45.1574 38.4668 38.0935 -15.0116 19.769 -34.2637 +1120 4 46.9934 39.487 36.0733 -14.8983 -9.5139 0.794979 +1121 4 44.1193 39.9156 35.4266 -15.9448 22.0113 -37.9939 +1122 2 45.2307 37.9502 34.8403 3.73878 29.7444 42.1248 +1123 2 44.043 37.0324 34.841 -52.9272 -13.7306 14.9234 +1124 2 45.6185 38.368 33.4399 7.42128 1.51593 -38.9882 +1125 4 46.0406 37.394 35.3664 8.69137 1.61483 -3.86581 +1126 4 43.4486 36.945 35.811 20.0159 3.18287 -12.2628 +1127 4 44.3645 35.9957 34.6605 0.118723 -8.68919 -11.9568 +1128 4 43.2413 37.3473 34.1301 7.80666 -3.9283 -7.25571 +1129 4 46.619 38.86 33.4411 -0.357581 -2.40345 0.816384 +1130 4 44.931 39.1517 33.0584 -3.3954 -0.0150932 -1.42103 +1131 4 45.65 37.5606 32.6192 -0.759822 9.78394 24.304 +1132 1 43.0637 38.9039 37.3301 16.2039 -1.11298 52.5829 +1133 2 42.3901 38.4825 38.6382 8.13363 32.9232 -36.228 +1134 2 41.8706 37.0909 38.467 10.8397 -12.8704 71.8875 +1135 3 41.4837 36.7016 37.4073 -23.2793 -18.8499 -56.9312 +1136 4 42.5052 38.9697 36.5072 -31.8536 4.61581 -21.2592 +1137 4 43.1805 38.4127 39.3754 18.2924 -0.774441 22.1039 +1138 2 41.3003 39.5089 39.1545 11.9555 -3.56475 0.849013 +1139 2 41.9844 40.8891 39.6202 11.8289 -38.672 35.4909 +1140 2 41.1032 0.170603 39.4187 0.299182 35.0028 -21.1028 +1141 2 42.4599 40.8175 41.1074 30.4283 -6.43954 -3.58257 +1142 4 40.7378 39.0113 40.0259 3.55617 13.764 -16.8053 +1143 4 40.5882 39.6834 38.2893 4.7664 -2.44084 15.6093 +1144 4 42.9174 41.0251 39.0897 16.4872 7.11459 -27.4623 +1145 4 41.5448 1.21778 39.6878 -5.64292 -30.3916 -9.38981 +1146 4 40.1969 0.063548 40.0003 -21.2204 -0.202137 11.1399 +1147 4 40.8028 0.152067 38.3319 -0.566182 12.1591 9.51378 +1148 4 41.6814 40.5448 41.8308 -8.42244 -8.91154 4.32363 +1149 4 42.887 41.7652 41.4977 -6.37808 7.37928 -6.87517 +1150 4 43.378 40.1338 41.1957 -24.337 0.845851 0.000130478 +1151 1 41.833 36.287 39.5864 -11.7269 -9.12911 -32.1296 +1152 2 41.2021 34.942 39.6247 -13.3362 -7.3841 -33.9439 +1153 2 39.8438 35.1095 40.3167 -2.23182 -18.8086 0.488263 +1154 3 39.8319 35.4679 41.5133 -14.6884 5.15074 -23.9167 +1155 4 42.1857 36.6275 40.4819 6.41783 1.01312 8.70708 +1156 4 41.0734 34.4248 38.4971 0.391294 34.8961 43.783 +1157 2 42.0436 33.9307 40.4129 10.4134 -33.9193 29.8386 +1158 2 41.3224 32.6645 41.0046 18.9395 -8.84266 -15.0635 +1159 2 42.1741 31.41 41.1086 26.4224 -37.0889 -5.20117 +1160 1 43.3231 31.527 0.12404 8.16009 54.2467 4.49909 +1161 2 44.392 30.7336 0.312631 -11.8213 -13.5239 -25.8004 +1162 1 44.683 29.6211 41.5456 -0.875823 -13.5136 -9.93246 +1163 1 45.3567 31.1357 1.10637 -40.5913 52.4111 16.4216 +1164 4 42.6035 34.3028 41.3288 -3.49471 12.9719 -23.3931 +1165 4 42.7742 33.539 39.6653 10.0701 4.50298 5.32726 +1166 4 40.5106 32.3417 40.3808 -25.7726 1.2565 -24.6898 +1167 4 40.8602 32.7415 0.05618 -15.4481 23.3498 31.3369 +1168 4 42.5775 31.2408 40.0556 -4.97325 -9.97334 14.9806 +1169 4 41.5239 30.4863 41.4302 18.1675 25.5375 -11.7586 +1170 4 43.4773 32.5278 0.495625 -12.2609 -36.3484 -6.98406 +1171 4 44.1847 29.2591 40.6938 -0.904676 10.2844 18.7349 +1172 4 45.5197 29.0942 41.8602 -5.70345 -5.08504 -8.10101 +1173 4 45.1981 31.9946 1.67722 9.89922 -9.52065 -4.53153 +1174 4 46.1063 30.5613 1.39407 36.7186 -26.409 10.0907 +1175 1 38.7328 34.6894 39.6013 4.46457 11.7984 -0.102478 +1176 2 37.3765 34.7683 40.1611 -21.3466 -3.56213 -4.53749 +1177 2 37.2086 33.6902 41.246 35.3807 -34.3386 -58.3615 +1178 3 37.7056 32.5617 40.9531 -12.3371 14.3328 36.9617 +1179 4 38.7903 34.2139 38.6548 1.70782 19.6852 25.699 +1180 4 37.2103 35.7436 40.6571 5.74575 10.1154 -0.0963519 +1181 2 36.2415 34.546 39.0669 -3.18027 -0.0437456 15.212 +1182 2 36.1408 35.6492 37.9204 39.4301 -27.8538 10.4422 +1183 2 35.3755 35.0392 36.7616 2.61616 7.91146 -44.6699 +1184 2 35.4893 36.9279 38.4153 -43.6456 26.6605 -35.0263 +1185 4 35.2587 34.5127 39.627 5.22859 0.340849 -7.95454 +1186 4 36.3572 33.4874 38.6664 0.260323 14.7009 0.217726 +1187 4 37.2087 35.8382 37.5664 -16.1128 3.65721 5.42823 +1188 4 35.4477 35.6456 35.7653 9.36321 -17.9472 26.5571 +1189 4 34.3056 35.0154 36.9225 -21.8403 -4.8414 12.2215 +1190 4 35.6878 33.9672 36.6241 -0.675121 9.51327 -11.2908 +1191 4 35.3533 37.7352 37.5449 14.646 -26.9923 30.0517 +1192 4 36.0883 37.365 39.2255 0.238586 8.99863 9.94523 +1193 4 34.398 36.7236 38.7331 27.4296 3.60145 2.66053 +1194 1 36.5178 33.9861 0.43319 -0.886806 18.5628 10.9627 +1195 2 36.4316 33.2481 1.68402 -23.714 -26.6299 -2.13495 +1196 2 35.1244 33.7124 2.42366 15.5385 -30.3313 2.36588 +1197 3 34.7644 34.9026 2.51705 2.20922 -14.5348 -10.7235 +1198 4 35.9714 34.8641 0.38304 3.21168 -9.87759 6.15105 +1199 4 36.3983 32.0948 1.44989 -1.82422 33.6343 5.26777 +1200 2 37.6595 33.5578 2.59019 11.8109 -15.526 -8.95992 +1201 2 37.7925 32.6548 3.8947 -1.46637 37.0951 -40.7395 +1202 2 39.0729 32.9162 4.76145 9.33062 17.9701 -6.69315 +1203 1 39.1272 34.3057 5.34055 -12.0513 -47.2871 -14.6565 +1204 2 40.0361 34.6964 6.22226 19.4309 2.99614 33.8109 +1205 1 41.0505 33.9844 6.76852 5.72064 -28.58 -41.8643 +1206 1 39.7581 35.8909 6.75898 -16.291 -41.0737 -43.8581 +1207 4 37.6558 34.6526 2.69615 5.74115 8.80853 20.4616 +1208 4 38.5677 33.342 1.97837 2.62182 1.38243 0.976295 +1209 4 37.7082 31.6119 3.52088 7.51898 -7.43262 10.1799 +1210 4 36.8684 32.8569 4.46033 -3.22235 -4.22142 15.6354 +1211 4 40.0987 32.7161 4.26669 -27.6432 -2.90908 0.926336 +1212 4 38.962 32.1623 5.56307 10.4764 0.325422 12.3641 +1213 4 38.2956 34.9173 5.26655 4.54825 -8.39051 -8.34855 +1214 4 41.5169 33.1039 6.38476 -28.6266 25.8655 1.14646 +1215 4 41.608 34.3491 7.51377 7.8916 19.9746 23.1278 +1216 4 38.9281 36.336 6.40181 -18.5651 19.0558 1.42199 +1217 4 40.2702 36.4189 7.40653 35.8571 19.9594 40.0309 +1218 1 34.4344 32.6714 2.9841 11.9274 27.4669 5.1488 +1219 2 33.2874 32.9292 3.81699 -8.08564 -7.68863 -5.88537 +1220 2 32.3224 31.7651 3.90854 -17.2979 -17.3182 38.1098 +1221 3 31.6331 31.611 4.98833 24.1293 6.49939 -41.9496 +1222 4 34.8176 31.7057 3.00707 -6.83555 3.8884 -0.368261 +1223 4 33.5991 33.291 4.83995 -4.39941 -8.915 -13.4113 +1224 4 32.6658 33.7351 3.38441 -0.220857 8.92322 -1.65762 +1225 1 32.2676 30.8833 2.86064 7.18924 -6.28537 -11.1453 +1226 2 31.5304 29.6622 2.84554 -44.3988 -8.55194 41.4736 +1227 2 32.0114 28.4719 1.98523 24.1065 42.5964 20.3644 +1228 3 31.2338 27.9142 1.1781 -2.45095 -15.5808 -11.9787 +1229 4 32.835 30.9065 1.99868 7.60542 11.1676 6.22148 +1230 4 31.4977 29.325 3.94534 -1.848 -5.68036 -21.1002 +1231 4 30.428 29.9278 2.63242 23.021 -11.1829 0.219584 +1232 3 33.2484 28.1785 2.03016 -12.1294 -5.65166 -6.61988 +1233 6 29.6841 33.0367 2.60309 -21.6771 -19.3453 -3.47113 +1234 4 28.7948 33.122 2.96731 -0.0142705 6.34055 1.55972 +1235 4 29.6278 32.12 2.27587 17.6678 13.2788 -5.74715 +1236 6 1.91248 24.7582 28.0699 4.20875 0.224039 17.8866 +1237 4 1.01839 24.445 28.2798 3.51323 0.855994 -2.65004 +1238 4 2.43926 24.5752 28.8738 -5.90795 -3.90565 -13.7536 +1239 6 8.97597 35.4266 7.06834 5.04 -9.06312 -1.25332 +1240 4 8.25108 36.0541 6.94232 -0.597114 -1.88223 0.564045 +1241 4 9.78632 35.9205 6.90416 2.6498 8.25727 -2.9232 +1242 6 37.9306 35.2271 23.5275 -29.4197 8.6633 8.88923 +1243 4 37.6331 35.3765 22.6307 -13.538 -1.59668 -6.74716 +1244 4 38.842 35.1051 23.4294 41.2281 -9.97035 -1.96517 +1245 6 11.37 34.6061 20.3231 29.8185 18.8627 -18.7977 +1246 4 10.4583 34.7066 20.5358 -23.2141 -5.0309 12.4901 +1247 4 11.7775 33.9686 20.9051 -0.738527 -14.291 8.66526 +1248 6 3.04799 13.1152 13.5136 35.0099 19.4917 13.0876 +1249 4 2.1896 12.8159 13.7818 -12.1985 -3.35561 6.33527 +1250 4 3.35102 13.7724 14.1976 -9.84998 -14.2313 -17.3692 +1251 6 9.17749 22.3786 24.885 -4.81993 3.49977 17.5169 +1252 4 8.99718 21.9861 24.0258 2.67933 0.293026 -6.97176 +1253 4 8.3097 22.5185 25.3032 2.93356 -2.2731 -6.67367 +1254 6 31.1417 36.1188 7.44168 3.96214 -4.62609 4.57576 +1255 4 30.9859 35.1633 7.26174 3.91063 19.8072 -8.10584 +1256 4 31.8759 36.4086 6.86762 -9.43736 -11.0335 0.220205 +1257 6 20.3122 0.171955 30.1364 24.228 8.43021 7.74329 +1258 4 20.1467 1.09565 29.8896 -9.06662 -5.17995 0.122132 +1259 4 21.2388 0.205679 30.4532 -11.6638 -2.99571 -4.85501 +1260 6 32.6752 3.01477 5.14905 7.73556 0.409651 25.0992 +1261 4 32.0607 2.27652 4.98052 6.16059 10.1356 9.58904 +1262 4 32.7887 3.0902 6.13894 -10.3787 -11.0045 -24.4474 +1263 6 26.2394 8.28697 11.5977 20.1187 4.68976 23.8355 +1264 4 26.2546 7.39802 11.997 -1.81228 7.23555 -2.12718 +1265 4 26.8422 8.82061 12.1901 -18.4274 -19.7459 -23.7973 +1266 6 1.08156 20.2558 0.892389 0.445896 -40.4816 -11.3523 +1267 4 0.921065 19.2784 0.845371 -9.22979 28.4068 22.5673 +1268 4 1.8129 20.2775 0.290341 19.5395 18.0975 -11.5753 +1269 6 29.152 22.9159 1.42964 -10.353 11.3862 1.77115 +1270 4 28.6638 23.7219 1.70393 12.045 -15.0113 -5.27942 +1271 4 29.6471 22.6066 2.20087 0.367353 7.17244 2.17898 +1272 6 34.1439 34.8173 6.47837 -14.6134 34.7664 -13.6599 +1273 4 34.8234 34.3556 6.01831 17.3611 -13.8412 -2.82442 +1274 4 33.8746 34.3136 7.2252 -0.385324 -14.0922 18.4225 +1275 6 25.1602 37.1811 26.5285 37.3138 -10.4299 -24.6025 +1276 4 24.6611 37.8475 26.9305 -29.1138 25.753 30.5337 +1277 4 25.9902 37.6718 26.3423 -2.02618 -10.7722 -5.27175 +1278 6 14.5359 22.233 15.6757 -38.1082 -52.4317 -17.2355 +1279 4 14.0373 21.3219 15.6008 31.4468 51.1923 15.0921 +1280 4 14.2115 22.7284 14.9124 6.42666 2.88962 4.6194 +1281 6 2.85765 5.85542 4.07926 -11.0889 31.9932 11.5474 +1282 4 3.43051 5.71014 4.8302 4.50985 -17.8875 11.7313 +1283 4 2.47546 6.74142 4.27679 -1.8522 -19.462 -7.62003 +1284 6 27.6173 26.7153 22.7048 3.02536 -24.7668 37.2 +1285 4 26.7794 26.2561 22.7471 -5.49099 -10.4557 3.23975 +1286 4 27.5338 27.2427 21.9498 -2.81898 29.5538 -40.3285 +1287 6 17.7815 0.60275 22.3967 -9.44347 22.192 16.8557 +1288 4 17.1106 0.664367 23.1174 8.05472 -4.70436 -13.4643 +1289 4 18.0991 1.53066 22.3547 -2.50437 -12.3009 -7.04453 +1290 6 8.08803 9.43976 10.5674 4.80966 -47.9744 28.0614 +1291 4 8.01535 10.2871 10.1695 -8.25869 32.7817 1.56345 +1292 4 8.12483 9.46261 11.5696 0.628604 12.1613 -30.4224 +1293 6 15.3459 8.71493 30.7579 -11.6347 7.91644 6.32427 +1294 4 15.6589 9.0755 29.9373 15.0271 -3.29406 -15.5675 +1295 4 14.5238 9.21191 30.8811 4.80809 -7.40019 11.405 +1296 6 11.0133 17.2839 37.5617 38.0352 -12.2544 -11.7999 +1297 4 10.7898 18.2056 37.405 -17.5453 -0.0751596 7.29682 +1298 4 10.2607 16.7791 37.8546 -17.0302 3.42722 4.74802 +1299 6 42.1004 25.1498 20.3879 -5.861 18.5914 -24.6259 +1300 4 41.6093 25.7579 19.7998 14.6917 -4.46771 2.10695 +1301 4 41.6207 25.2703 21.1911 -4.19275 -5.86855 25.2901 +1302 6 25.8665 4.70671 33.8486 1.7241 -2.25531 12.4518 +1303 4 25.7694 4.46132 32.9448 -0.891619 -14.6084 -22.569 +1304 4 25.7648 5.65611 33.7952 0.475958 14.7418 11.4125 +1305 6 28.7412 10.81 24.3536 52.8166 -39.1996 0.778281 +1306 4 29.1275 10.6396 25.241 -21.7381 14.0631 -10.6288 +1307 4 29.4032 10.2753 23.8346 -27.1554 16.6107 -4.2243 +1308 6 5.01189 41.8147 11.1021 -10.1881 -24.042 21.7575 +1309 4 5.95007 41.5814 10.9281 -9.39093 5.64723 11.7156 +1310 4 4.65803 41.218 11.8386 16.8172 15.7397 -32.6044 +1311 6 51.752 12.7769 30.1551 43.115 4.76279 10.9474 +1312 4 51.4305 13.1775 29.3474 0.253404 7.28674 -13.194 +1313 4 52.748 12.9494 30.1798 -32.3905 -5.4963 0.108494 +1314 6 7.60816 6.20909 6.53323 -10.2625 -22.9413 3.332 +1315 4 6.75131 6.36879 6.93991 1.04412 16.1391 1.16177 +1316 4 7.47061 5.28848 6.27373 8.51121 0.713964 -9.51027 +1317 6 14.6661 26.987 30.1548 0.873164 4.36141 0.355215 +1318 4 14.582 27.1099 31.1251 1.36022 -4.92112 -14.8153 +1319 4 15.2266 27.7026 29.8055 -8.21389 -0.931444 11.6021 +1320 6 15.3264 3.73283 21.1643 -10.33 -3.58504 -6.01241 +1321 4 14.8638 4.27764 21.8464 -0.83547 -19.2341 -16.6374 +1322 4 14.7237 3.15769 20.6119 12.9204 22.2517 21.9232 +1323 6 18.6273 30.44 6.46759 12.0392 -23.7352 17.6185 +1324 4 19.0475 29.6706 6.98693 -16.3462 35.3997 -15.3304 +1325 4 19.3457 31.0864 6.33287 -5.93154 -6.64461 4.30044 +1326 6 40.7697 1.30953 12.81 -7.42069 2.69181 -0.220133 +1327 4 39.8771 1.67487 12.9664 8.30469 -1.85755 -8.75546 +1328 4 41.0842 1.69163 11.9727 1.23155 -3.30642 0.910493 +1329 6 17.7383 20.7435 41.5913 -9.25323 7.68498 -13.188 +1330 4 16.7989 21.0745 41.5362 27.0903 -5.35562 -1.00027 +1331 4 18.2994 21.1605 40.9095 -9.45455 4.50919 10.4973 +1332 6 20.4558 2.13279 12.3403 -30.0447 18.1891 -47.0851 +1333 4 19.8108 1.39557 12.2573 15.3988 9.29294 19.6505 +1334 4 20.198 2.64755 11.5038 12.9177 -17.2886 33.121 +1335 6 9.85302 37.1833 18.074 6.71136 -14.9304 -23.7857 +1336 4 9.92221 37.5908 18.9423 10.0316 4.42551 4.50256 +1337 4 10.7455 37.1149 17.635 -18.8442 6.56171 18.5414 +1338 6 22.8282 7.40677 18.9114 -6.23678 0.804763 -35.7596 +1339 4 23.277 7.74075 18.0859 -11.7777 -2.90663 21.4919 +1340 4 21.8757 7.287 18.6972 16.9035 1.85128 0.334711 +1341 6 12.8573 6.85868 39.0594 6.78943 -21.4649 -19.4044 +1342 4 12.3495 7.63841 39.2092 -16.9303 20.8315 3.03628 +1343 4 13.4346 6.77393 39.8096 4.28484 1.06254 16.6435 +1344 6 10.1565 2.40612 23.2517 -6.6479 23.561 31.1588 +1345 4 10.4099 1.98923 22.4441 -4.01424 -6.38426 -29.0568 +1346 4 9.49005 3.10319 23.0571 9.63138 -11.2124 -3.87372 +1347 6 12.5542 20.2161 19.5705 -7.34833 3.07917 -34.9419 +1348 4 11.7057 19.8107 19.7825 -3.93433 -3.45282 3.31954 +1349 4 12.4683 20.3478 18.5882 13.2674 0.522362 30.6915 +1350 6 53.8557 6.35775 18.9347 50.5758 7.3162 -16.743 +1351 4 53.0168 6.07594 19.2456 -23.2698 -10.9568 16.0684 +1352 4 54.5479 6.04339 19.5529 -19.4302 5.44353 -5.27334 +1353 6 1.75058 4.00903 13.2441 23.5728 -28.6973 -20.2265 +1354 4 1.21884 4.54583 13.7916 -24.4496 15.7193 15.6535 +1355 4 1.39876 3.10072 13.3493 7.47096 11.1043 -1.96467 +1356 6 2.68902 16.4655 4.58797 17.5454 -16.7281 26.1549 +1357 4 3.46748 16.2798 5.17846 -23.6637 11.3752 -17.7986 +1358 4 3.0109 17.1109 3.97132 2.36318 9.59715 -15.9168 +1359 6 22.6274 7.40182 35.0529 -33.099 -8.93325 -69.8706 +1360 4 21.8922 7.07895 34.3703 46.348 20.1786 48.898 +1361 4 22.5995 6.76718 35.7474 -8.35572 -20.8537 22.0506 +1362 6 30.6396 27.885 19.9 19.0923 35.3411 -25.0547 +1363 4 31.1106 28.5954 19.3754 -18.5592 -24.8751 19.2783 +1364 4 29.9814 27.5098 19.295 5.17179 -8.35919 5.46264 +1365 6 18.3573 9.54392 6.2041 9.96047 7.12844 39.1223 +1366 4 18.327 9.09374 5.37857 3.10343 -12.6247 -24.8999 +1367 4 19.1177 9.18386 6.70986 -9.9052 0.872737 -11.1311 +1368 6 21.018 30.3894 30.8381 -12.2875 -2.46479 40.1773 +1369 4 21.7266 31.0151 30.932 9.98027 8.24448 -8.07198 +1370 4 20.7269 30.28 31.7939 -0.642204 -5.24287 -40.3987 +1371 6 28.323 4.36597 15.0837 1.12527 39.8195 10.6489 +1372 4 27.8986 3.55092 15.2676 -12.4099 -32.2848 2.02696 +1373 4 29.0009 4.19376 14.4446 14.1396 -7.65384 -8.86362 +1374 6 12.7814 0.64254 16.5262 -20.2521 41.8336 -1.49998 +1375 4 13.0387 1.47629 17.0069 -1.64601 -27.4009 -13.133 +1376 4 12.0897 0.933072 15.8712 20.715 -4.46996 16.4219 +1377 6 27.5603 35.1844 8.24072 -26.8161 -1.20469 12.7263 +1378 4 28.0791 35.3455 7.47089 6.94403 2.76433 -19.537 +1379 4 26.8275 34.582 7.96906 18.9853 12.4469 9.56437 +1380 6 24.0704 5.17451 40.9985 43.9791 -14.9803 45.716 +1381 4 24.6298 5.96615 41.2045 -19.6374 -8.83437 -20.0494 +1382 4 23.3625 5.28724 40.4007 -22.1054 20.8081 -27.5224 +1383 6 16.8467 24.9145 28.3061 -32.8066 71.0274 -23.4158 +1384 4 15.8676 25.1613 28.454 39.6061 -31.4713 1.92714 +1385 4 17.0718 25.6559 27.6632 3.37355 -28.1253 20.4487 +1386 6 20.8411 12.7971 17.0095 43.3655 -24.1139 -5.17775 +1387 4 20.9692 13.6698 17.4217 0.0861137 -1.96629 -7.53612 +1388 4 21.7712 12.4167 16.7645 -47.1299 18.5523 16.3808 +1389 6 35.7683 23.0344 30.9263 1.08866 -13.108 5.55839 +1390 4 34.803 23.1301 30.928 3.64223 -3.31893 2.04139 +1391 4 35.9803 22.5404 31.7512 0.26244 15.2618 -11.5602 +1392 6 36.3065 21.404 25.8788 21.1988 16.3215 -11.4752 +1393 4 35.3711 21.2912 25.8279 -29.04 -8.19979 -7.71966 +1394 4 36.6742 20.6179 26.2596 7.44281 -15.7003 9.85929 +1395 6 13.4865 6.74911 5.29345 -32.6693 78.3701 45.7352 +1396 4 13.9616 6.05619 4.98306 41.5093 -80.328 -47.9816 +1397 4 12.7805 7.00791 4.71674 -14.9335 -5.37764 -13.3979 +1398 6 20.8104 20.4092 13.7653 1.99296 11.0688 -14.7475 +1399 4 21.268 20.4545 14.5989 11.9976 -3.76106 7.6647 +1400 4 19.8959 20.3184 13.9984 -15.4264 -4.27358 -1.02469 +1401 6 20.3637 29.125 1.38742 -7.39452 3.20569 15.6829 +1402 4 20.6257 29.8678 1.97015 -13.6171 -7.9879 -3.97808 +1403 4 19.4728 28.7955 1.69287 22.5847 10.4694 -9.78123 +1404 6 50.8792 13.1212 37.2655 -4.22961 23.9091 37.9372 +1405 4 51.3893 12.5589 37.8771 -2.47029 4.54984 -9.0483 +1406 4 50.5869 13.8674 37.8656 5.03029 -21.5284 -25.2034 +1407 6 33.9282 34.1694 20.494 -12.758 16.9363 4.62304 +1408 4 33.9505 34.3661 19.5368 -1.52487 0.481952 13.5649 +1409 4 33.2327 34.7631 20.901 14.0918 -19.53 -17.3949 +1410 6 26.2111 28.0581 27.5584 -15.6012 -12.4051 -9.62147 +1411 4 26.6887 28.3319 28.3498 -5.67664 4.83839 -0.885474 +1412 4 25.2376 28.0657 27.7416 20.5709 -1.16679 -1.23567 +1413 6 7.682 21.3042 4.28531 -31.6563 9.11884 52.3302 +1414 4 8.36407 20.9023 3.81015 41.1991 -18.6864 -33.8238 +1415 4 7.19271 21.9105 3.74865 -6.01459 10.7978 -19.2095 +1416 6 22.0049 15.1615 5.91526 -5.59087 32.8095 7.59658 +1417 4 22.5291 15.4011 5.14076 -1.79158 -8.25489 -6.60562 +1418 4 21.8369 14.2416 6.04435 2.97447 -25.4321 -3.26552 +1419 6 21.7136 24.0096 3.8157 22.5859 -13.9702 -11.1371 +1420 4 22.6792 24.1846 3.95073 -20.2229 4.30251 2.28349 +1421 4 21.6957 23.2604 3.18041 -1.04284 4.75891 13.5064 +1422 6 11.5672 23.7812 12.5534 10.6653 17.5289 -0.525849 +1423 4 11.8567 24.7317 12.4283 -11.704 -31.033 2.93832 +1424 4 11.2483 23.6794 13.4494 -5.02459 5.94744 7.15157 +1425 6 32.3679 18.058 29.8144 -2.59991 12.5874 27.6023 +1426 4 33.2958 17.8537 29.9681 1.40206 -2.08885 -2.88861 +1427 4 32.1708 17.8352 28.9168 3.64727 -16.5589 -23.8097 +1428 6 9.27501 12.3901 30.3257 8.89695 -9.73537 -4.18026 +1429 4 8.97738 13.0169 30.9954 -4.04452 2.00113 -0.0309771 +1430 4 10.1278 12.0418 30.6776 -19.7256 9.24572 -11.0885 +1431 6 40.1671 25.9203 9.1352 -31.1658 -6.55029 4.71016 +1432 4 40.7952 25.2818 9.45931 8.36253 -10.0667 -0.250848 +1433 4 40.6474 26.7215 9.01492 17.3912 21.2934 -6.4579 +1434 6 43.1616 32.3487 37.3267 7.45809 -19.2286 11.3512 +1435 4 42.8399 32.8446 36.5586 -11.2032 -5.45956 10.184 +1436 4 42.4733 31.7245 37.6799 8.3011 17.0164 -20.2151 +1437 6 44.0911 6.28198 31.259 8.64406 -6.47735 -33.2401 +1438 4 43.4563 6.84482 31.6606 -21.1773 24.4303 10.8162 +1439 4 44.5952 5.92873 31.9644 15.9286 -14.2375 24.3689 +1440 6 10.2063 18.8787 19.6978 14.6089 -0.63771 -2.74842 +1441 4 10.128 18.3979 20.5267 6.04825 -4.13467 -1.20166 +1442 4 9.36891 19.3219 19.635 -15.0357 8.38504 -1.1225 +1443 6 7.0561 15.5922 15.0299 -16.4573 19.9198 -23.3889 +1444 4 7.18612 15.4783 14.0721 1.05096 2.95086 4.94392 +1445 4 7.41457 14.833 15.4354 13.8635 -34.6267 13.25 +1446 6 24.544 3.4899 27.8655 -14.5565 -8.97091 -7.81951 +1447 4 23.6823 3.28725 28.2588 1.61952 11.0081 14.175 +1448 4 24.3729 3.16547 26.9791 10.0044 -2.74415 -7.35546 +1449 6 54.4109 31.8087 9.71194 -6.99911 23.6955 33.3298 +1450 4 53.8413 31.5567 9.00593 -8.22136 -4.9258 -26.1741 +1451 4 54.0752 32.6964 9.97695 10.2913 -15.383 -7.59421 +1452 6 6.81072 17.0817 36.2069 -39.6649 -0.569341 -18.8672 +1453 4 5.9036 16.7161 36.0961 17.2423 3.35707 18.397 +1454 4 7.03883 17.1994 35.2786 19.8939 2.17194 6.76773 +1455 6 28.6373 7.46216 20.4204 -3.00228 3.72915 -26.9716 +1456 4 27.791 7.71165 20.8314 -1.23568 -3.59083 -7.19581 +1457 4 28.5788 7.67124 19.4449 -3.89686 1.20908 30.1283 +1458 6 17.0427 1.7136 8.36469 -7.39711 4.96373 -17.441 +1459 4 16.9511 0.79552 8.17539 8.34993 -30.6792 14.2707 +1460 4 16.7364 2.03503 7.50962 2.58977 23.9868 7.32556 +1461 6 19.1319 19.334 35.5748 25.2315 11.3156 3.71898 +1462 4 18.4163 18.7293 35.4559 -12.7574 -15.0058 -3.77114 +1463 4 19.9108 18.8059 35.8312 -7.49406 2.79856 2.97864 +1464 6 7.31044 31.3665 13.5876 -12.5896 -10.3186 -18.1643 +1465 4 6.86348 30.5057 13.838 5.41483 30.5465 -8.86898 +1466 4 6.71656 31.9291 13.023 7.05746 -22.9991 7.02109 +1467 6 16.6555 5.24573 12.8486 0.44122 -36.1931 20.2204 +1468 4 17.4189 5.79101 12.9112 23.6003 17.0932 2.01526 +1469 4 16.8511 4.45507 13.4194 -12.0332 11.5633 -21.5138 +1470 6 43.8917 12.7482 34.58 -33.2024 -13.6106 -1.45858 +1471 4 43.9807 13.5999 34.156 2.60816 15.5254 -0.13451 +1472 4 42.9242 12.5381 34.5161 22.3754 -3.96122 -2.5942 +1473 6 42.656 36.4522 28.5282 -7.17959 22.9727 1.13167 +1474 4 42.279 37.3416 28.6522 -7.55712 -15.8866 -0.526154 +1475 4 43.5285 36.675 28.2003 16.3904 -10.8581 0.329061 +1476 6 35.3704 15.0467 6.02622 35.7531 43.3754 17.6476 +1477 4 35.9258 15.8884 5.86958 -26.5611 -35.5954 0.991204 +1478 4 34.7923 14.9488 5.27074 -5.69332 -0.0870189 -10.0798 +1479 6 19.4034 5.85396 6.19026 -42.6676 -37.2433 -25.4755 +1480 4 18.4973 6.11578 6.46985 14.7962 -6.51198 7.73248 +1481 4 20.0178 6.47164 6.48735 29.6225 43.4574 23.1864 +1482 6 29.2636 38.16 6.98139 -51.0091 34.2659 0.167673 +1483 4 28.4794 38.0546 7.56687 16.6219 5.90534 -14.0005 +1484 4 29.8812 37.5458 7.29338 34.0617 -33.3732 10.6718 +1485 6 19.3639 26.1879 8.4772 -1.75021 -19.5484 18.4946 +1486 4 19.3765 25.7536 9.37133 0.505418 11.6152 -20.7618 +1487 4 20.132 25.8039 8.02679 -2.64689 1.58972 6.88257 +1488 6 4.91801 16.6546 6.12902 16.8332 -1.31437 8.04366 +1489 4 5.58152 17.3 5.84506 -6.45866 4.1219 -0.991793 +1490 4 5.39084 15.8022 6.09449 -7.75564 17.9483 -2.53018 +1491 6 6.07873 16.6931 28.0679 20.4204 4.35008 -35.2212 +1492 4 5.19925 16.4426 27.8453 -29.7482 -9.15572 9.47762 +1493 4 6.44387 16.7631 27.1426 -3.77999 2.92972 38.3228 +1494 6 21.7313 29.3584 22.0941 -19.989 26.599 40.0594 +1495 4 21.5191 30.3374 22.0902 3.30888 -28.6715 -0.0155919 +1496 4 21.2646 29.0087 22.9228 20.4195 8.84702 -28.341 +1497 6 24.487 0.545827 12.8459 24.5625 -19.0276 8.44191 +1498 4 24.0381 0.883409 12.0817 -9.22903 10.6064 -10.7293 +1499 4 24.0836 0.980384 13.5911 -6.14963 8.46579 8.44801 +1500 6 18.4109 28.2545 40.3162 -15.9129 36.5713 -32.2972 +1501 4 18.3366 27.7076 41.0573 0.952339 -31.6797 34.0712 +1502 4 19.1875 27.9677 39.8503 10.0284 -2.61836 -5.50219 +1503 6 10.3807 17.4604 21.8947 -1.20821 -16.3296 3.13877 +1504 4 9.80057 16.6779 21.8113 10.8468 3.86983 1.60142 +1505 4 10.0443 17.9356 22.6521 -9.33664 9.03137 6.2204 +1506 6 13.5404 13.3591 39.6327 12.5768 11.767 30.0264 +1507 4 13.9188 14.1992 39.2886 -9.97897 -11.5724 13.3172 +1508 4 13.5464 13.3749 40.6413 1.33606 5.90172 -38.0522 +1509 6 19.5508 26.0247 24.7387 -47.8665 -1.21537 -13.2845 +1510 4 19.6189 25.3328 24.097 -5.62542 -9.91951 -19.3965 +1511 4 20.3649 25.9852 25.1641 45.3739 3.88293 31.7071 +1512 6 8.93445 25.8823 20.0822 -10.4543 -29.9419 8.18251 +1513 4 8.35083 26.4773 20.5043 -33.2288 11.519 27.1484 +1514 4 9.504 26.5029 19.6962 43.6798 16.1155 -28.0388 +1515 6 13.4493 41.2138 30.5102 -4.84662 -36.1256 25.75 +1516 4 14.2597 41.094 31.0483 -5.58856 8.18726 -8.9115 +1517 4 12.8416 40.5025 30.8796 12.8197 27.661 -18.9522 +1518 6 21.1596 21.6794 11.1163 10.7366 20.8259 2.41134 +1519 4 20.9554 20.8709 10.6777 -10.2383 -24.5438 -10.817 +1520 4 21.2276 21.4421 12.046 -2.84377 -3.57945 5.82209 +1521 6 43.5643 10.3136 15.5616 17.5969 -21.741 5.94749 +1522 4 43.2379 9.48961 15.149 2.99942 14.1859 3.68588 +1523 4 42.9802 11.0242 15.3396 -21.8087 10.2132 -10.2755 +1524 6 23.5302 5.07333 12.3088 -23.5628 55.8128 -25.3063 +1525 4 23.4112 4.1923 12.0373 1.19089 -49.3933 -5.08619 +1526 4 23.0178 5.53904 11.5656 24.5614 -12.3881 30.382 +1527 6 9.28539 15.401 4.24759 1.63269 -5.62651 -9.8947 +1528 4 9.02922 16.1115 4.82738 -12.4128 14.4693 4.40189 +1529 4 9.90895 14.9318 4.78697 15.8319 -9.58935 3.85081 +1530 6 26.711 10.8797 17.566 5.43365 -10.3343 -26.0937 +1531 4 26.4818 11.0142 18.4585 -6.06422 3.32013 41.5711 +1532 4 26.8019 11.7518 17.1937 0.341074 3.88847 -5.26754 +1533 6 26.0592 23.5875 33.6794 25.1455 50.9154 21.2543 +1534 4 25.4682 24.0785 33.1024 -8.24785 -6.01089 -9.80751 +1535 4 26.6604 24.3213 34.0779 -26.6739 -38.162 -12.8336 +1536 6 7.57385 10.4949 28.9097 -14.7972 2.07126 0.456687 +1537 4 6.75277 10.5859 29.4011 -5.17598 -12.8295 -3.89358 +1538 4 8.06091 11.2035 29.3139 24.0536 5.38729 3.77373 +1539 6 16.4953 16.9073 24.6459 13.4535 22.6993 31.6086 +1540 4 15.9363 17.7011 24.6942 7.46422 -1.49957 -9.096 +1541 4 16.1467 16.4045 23.9375 -12.5815 -17.1437 -28.632 +1542 6 12.5505 12.7927 0.441559 26.7797 -18.4986 61.4448 +1543 4 12.8902 12.7839 1.42408 -16.6807 15.1369 -51.7767 +1544 4 12.972 11.9767 0.117581 -17.3776 3.59908 -10.4186 +1545 6 6.80454 2.46926 9.04378 10.3033 -16.1572 19.5551 +1546 4 7.05376 2.92505 9.85651 -1.04006 9.78535 -3.84035 +1547 4 7.36555 1.67892 9.06596 -6.07141 -1.3767 -9.09165 +1548 6 28.8788 11.8454 12.005 47.3119 33.3239 7.75537 +1549 4 28.2175 12.4307 11.6211 -4.89696 7.77957 0.00959457 +1550 4 29.7805 12.2922 11.8721 -37.0304 -14.6121 1.30522 +1551 6 44.6756 32.5924 29.7091 -46.8228 -4.47104 18.0754 +1552 4 43.7214 32.9254 29.5641 42.8383 -8.78111 -1.84094 +1553 4 44.558 31.8742 30.3802 4.31467 20.1075 -17.1439 +1554 6 28.6099 15.1189 32.288 -8.09168 -64.7739 -6.10589 +1555 4 29.0591 15.887 31.9855 13.2175 18.1439 -15.8441 +1556 4 29.0109 14.3064 31.825 -10.272 37.9041 18.9788 +1557 6 1.13952 22.1955 33.6303 -59.4889 25.247 28.7943 +1558 4 0.675447 22.8098 33.0333 5.4615 -9.68619 7.91413 +1559 4 1.8611 21.9185 33.1521 52.5767 -22.4691 -40.0321 +1560 6 17.4529 16.8222 9.92046 -20.0761 -24.0842 48.1247 +1561 4 17.9341 17.1517 9.19999 21.5054 13.464 -32.8219 +1562 4 17.9802 16.1035 10.3295 -2.40424 8.44812 -14.2536 +1563 6 18.74 29.8021 14.3918 16.1488 4.65404 69.9188 +1564 4 19.5966 29.6355 14.8679 -24.5899 1.22938 -11.6521 +1565 4 18.9027 29.6655 13.4911 13.4763 -5.12933 -46.2854 +1566 6 39.4106 6.51176 13.0171 8.18439 9.54271 -9.98348 +1567 4 39.7968 7.3217 12.6105 -7.82756 -18.4389 5.68309 +1568 4 39.8965 5.76959 12.6221 -1.11983 7.69721 6.02388 +1569 6 54.1122 38.2735 14.316 -26.3921 15.7841 23.5556 +1570 4 53.5092 38.7211 14.9446 14.1224 -15.8084 0.476194 +1571 4 53.7657 38.6747 13.5269 5.67525 0.359642 -25.5906 +1572 6 7.51656 32.0218 20.9281 34.7748 10.0158 34.1931 +1573 4 7.08362 31.9253 20.1193 -22.6959 2.07513 -43.8223 +1574 4 7.03544 31.4175 21.4603 -12.2713 -14.4046 24.4342 +1575 6 26.9722 15.5137 13.836 8.2831 -9.07996 -12.1546 +1576 4 27.2905 14.6773 14.2204 -10.3825 7.39938 7.42218 +1577 4 26.0228 15.629 13.9568 -6.27371 -3.74993 11.5294 +1578 6 18.3731 16.4369 32.1258 -5.47484 6.15837 -16.1574 +1579 4 18.1737 16.7054 31.2071 -0.945967 -8.38127 9.44724 +1580 4 19.0036 17.0959 32.4159 12.6478 4.85619 3.13766 +1581 6 52.4904 31.6749 23.2282 -45.8236 3.94874 65.5164 +1582 4 52.5054 32.2301 24.055 -6.11863 -14.7847 -21.5508 +1583 4 53.2278 31.9578 22.7624 44.676 11.2926 -39.5338 +1584 6 2.17063 9.69676 28.2025 -10.599 22.0242 17.0864 +1585 4 2.41083 10.574 27.888 12.6445 -0.15763 -12.1006 +1586 4 1.36653 9.91172 28.7063 1.66945 -10.1846 4.32482 +1587 6 32.9295 0.084333 22.579 -26.8721 -17.4052 -13.8633 +1588 4 33.2309 41.109 22.2818 0.690852 17.8844 8.89147 +1589 4 33.6446 0.598803 22.932 23.7791 -0.031599 0.0852179 +1590 6 20.7171 41.5453 38.643 51.9522 19.855 -62.1487 +1591 4 20.0643 41.0408 39.0691 -29.2365 -22.9372 13.5286 +1592 4 20.9788 41.0468 37.7869 -12.0924 18.2625 49.3819 +1593 6 43.2965 24.3242 12.1559 29.4143 27.7167 -28.3716 +1594 4 43.2964 25.2918 12.2975 -10.3211 -14.9579 7.88207 +1595 4 44.0244 24.2792 11.4826 -12.2932 -11.2644 22.4039 +1596 6 22.0333 36.2992 11.8143 -17.8744 11.1706 -5.23693 +1597 4 21.6038 36.9407 11.2131 12.0614 -9.84488 11.7859 +1598 4 22.8639 36.0559 11.3996 4.49067 -2.6397 -1.6843 +1599 6 50.7446 20.5307 30.3299 -19.4296 24.1009 0.394401 +1600 4 50.3769 20.0585 31.0978 -4.60399 -0.499453 -6.82258 +1601 4 50.1204 21.2977 30.1594 19.9431 -26.9935 4.34337 +1602 6 20.8379 3.84934 18.1872 -10.63 2.24574 17.9634 +1603 4 21.6372 4.15439 17.7675 6.81748 4.13844 -2.44268 +1604 4 20.7537 4.31685 19.0447 1.53322 -4.30004 -12.0579 +1605 6 4.001 20.6421 6.99361 -18.7611 -9.71733 3.72301 +1606 4 3.09723 20.6004 6.53941 30.5715 -8.65918 22.3858 +1607 4 4.00786 20.2035 7.89591 -15.2068 14.2544 -28.772 +1608 6 11.948 15.4413 41.4409 9.86263 -45.3449 -5.39948 +1609 4 11.9713 14.4541 41.6361 -2.32711 35.624 3.02695 +1610 4 12.4708 15.4889 40.6181 -5.28805 11.0492 6.42 +1611 6 3.00764 18.5435 38.9252 6.90717 -29.584 40.0663 +1612 4 3.56523 17.7255 38.8717 -9.75827 16.9893 -1.25399 +1613 4 2.92934 18.9138 38.0721 -1.66709 15.3109 -35.9518 +1614 6 8.5978 38.8858 11.3072 48.4025 32.5603 4.46589 +1615 4 9.44036 39.0024 10.7943 -20.5341 -1.07382 9.55064 +1616 4 8.19448 38.1327 10.9484 -22.3544 -46.6733 -17.9601 +1617 6 12.9691 33.9778 38.4933 34.8069 -13.3685 -21.4899 +1618 4 12.6573 33.2385 37.9471 -9.06758 1.22663 10.2849 +1619 4 13.9307 33.983 38.2659 -20.4066 10.3952 14.8996 +1620 6 4.69069 11.9902 6.04709 5.57568 0.955193 2.63183 +1621 4 3.83092 11.6207 5.79405 1.19943 -2.71585 -3.65246 +1622 4 5.36696 11.7708 5.36999 -19.9658 -4.94035 2.87891 +1623 6 10.8381 15.9154 25.2196 -36.4648 2.02786 -4.38258 +1624 4 11.7191 16.2167 25.3262 31.8449 11.9168 5.4517 +1625 4 10.3518 16.6682 24.8476 5.65772 -8.76316 -0.529027 +1626 6 20.7604 3.23767 6.55488 4.15603 28.9608 0.670607 +1627 4 20.2106 2.56517 6.18958 -7.79877 -24.0058 -5.45951 +1628 4 20.2434 4.04703 6.45055 -2.36445 1.41903 2.77062 +1629 6 47.6381 39.1588 31.2153 -11.506 28.7103 -40.9212 +1630 4 46.7125 39.0803 30.8864 16.1685 3.01672 12.9065 +1631 4 48.0161 39.883 30.6238 -10.851 -36.2784 24.6994 +1632 6 8.33868 27.7571 27.6932 -33.938 3.65348 13.4266 +1633 4 7.90796 26.9962 28.1436 6.90464 18.5991 -0.450451 +1634 4 9.05762 27.3551 27.2376 19.8804 -10.068 -12.1598 +1635 6 33.245 40.3099 33.4253 18.3517 22.2199 -28.9554 +1636 4 32.5937 41.0038 33.2194 0.94932 -12.4457 9.89811 +1637 4 33.9479 40.492 32.7526 -7.59275 -9.33057 17.0692 +1638 6 24.5058 34.6327 27.2588 -1.70215 14.4876 -27.3243 +1639 4 24.8356 35.5409 27.0166 -5.53884 -24.0927 13.0812 +1640 4 24.1351 34.315 26.3934 7.47117 3.95694 29.9195 +1641 6 13.3256 36.76 35.7403 23.371 22.3884 -21.319 +1642 4 14.292 36.6204 35.8687 -19.0607 -2.42845 14.454 +1643 4 12.8134 36.0651 36.1242 -8.79549 -23.1532 9.33092 +1644 6 34.0568 20.1616 33.2139 18.2744 1.49148 -3.34215 +1645 4 34.901 20.3965 32.7524 -27.9907 10.0382 9.43414 +1646 4 33.5726 20.9405 33.5892 13.555 -8.0917 -8.63642 +1647 6 22.8329 33.5616 31.6214 -12.6844 15.5573 -21.5595 +1648 4 23.5755 34.1858 31.5969 1.53708 -3.14405 -0.637663 +1649 4 23.0292 32.8658 32.2325 13.4469 -12.4025 17.113 +1650 6 23.7434 2.42786 19.8498 9.49596 22.5629 12.9133 +1651 4 24.532 1.90722 19.7117 15.1933 -8.07802 -2.32773 +1652 4 23.0629 1.99408 19.3682 -23.4605 -15.8437 -14.4607 +1653 6 10.59 1.63974 20.5169 -0.95575 -6.83071 6.14558 +1654 4 9.98705 1.03236 20.0473 7.71399 2.84727 3.14747 +1655 4 10.6246 2.47233 20.0276 -8.35822 1.7372 -3.87231 +1656 6 6.50082 24.8628 7.81243 5.63459 3.09475 -4.38693 +1657 4 7.40706 24.9537 7.44087 -14.825 -10.0154 1.3351 +1658 4 6.01351 24.1359 7.38457 10.3118 5.93376 -6.27471 +1659 6 54.7907 32.5298 25.4601 2.42441 14.1538 -12.299 +1660 4 54.0693 33.194 25.3949 12.697 -15.3913 -0.923548 +1661 4 0.387469 32.6052 24.6546 -22.4501 -0.197402 25.3904 +1662 6 6.24565 20.1804 28.9699 -20.0835 16.2671 13.5362 +1663 4 5.37616 20.2206 28.5173 17.3942 -4.89439 1.50138 +1664 4 6.85708 19.7029 28.4106 5.94408 -11.9876 -6.03836 +1665 6 50.061 21.6087 11.3404 -11.515 44.0552 -42.0488 +1666 4 50.9725 21.751 11.0493 2.56545 -3.3262 -1.97817 +1667 4 50.0662 20.9568 11.9903 8.13397 -42.2403 36.0281 +1668 6 43.4741 33.5215 19.648 39.1267 -7.16957 -40.9914 +1669 4 43.8052 33.5504 20.5247 -1.27694 2.64583 28.8889 +1670 4 42.5461 33.5822 19.6063 -36.855 5.29583 12.3512 +1671 6 30.8225 7.19458 41.0729 -33.0718 18.8928 10.1641 +1672 4 30.0173 7.64992 40.6345 32.3343 -18.9847 22.962 +1673 4 30.7853 7.47469 0.131591 -1.52838 -8.42988 -38.7943 +1674 6 12.1264 25.8478 11.0965 -41.5825 -1.76886 -24.0951 +1675 4 11.2804 25.9828 10.5746 22.2453 -8.09118 27.7312 +1676 4 12.6111 26.6214 10.8799 25.9351 22.819 -1.42381 +1677 6 47.8207 5.82713 17.7363 28.7614 -16.7343 -8.46055 +1678 4 48.0335 5.15295 17.0353 -2.74159 24.5551 13.4979 +1679 4 48.6986 6.12754 18.0988 -19.3132 -4.26463 -8.98138 +1680 6 35.1697 12.9074 16.5814 -26.6969 23.1645 14.7724 +1681 4 35.331 12.9801 17.5341 9.94288 -5.95548 -5.31324 +1682 4 34.5116 13.6489 16.4838 18.7069 -22.8028 -11.189 +1683 6 10.4746 10.6344 33.9856 -30.1195 -20.4446 -6.31426 +1684 4 10.7944 11.3866 34.5009 -4.55531 -6.56386 0.452866 +1685 4 9.59186 10.377 34.349 25.6427 10.4215 -3.60637 +1686 6 9.86976 7.46809 9.66723 13.2706 -15.2427 -11.6817 +1687 4 9.07254 8.00079 9.6953 0.322066 10.4083 -1.78771 +1688 4 10.1027 7.29929 8.72005 -15.6005 8.2826 19.6359 +1689 6 11.1498 9.5629 29.1446 -4.60031 -6.3451 3.75047 +1690 4 10.6862 9.26798 29.9509 5.10767 2.07156 -10.4371 +1691 4 11.3249 8.76682 28.6116 2.75639 0.845127 6.4689 +1692 6 46.3982 12.7571 37.8973 13.0728 8.65129 -14.0384 +1693 4 46.6651 13.0033 36.9771 -6.5436 -6.98702 17.4091 +1694 4 46.8422 13.384 38.4935 -4.33131 -5.25976 0.421567 +1695 6 4.7745 19.0249 15.9997 -22.3762 2.96494 22.3523 +1696 4 4.16029 19.0173 16.7572 4.82074 7.85299 -8.34635 +1697 4 5.51792 18.5695 16.4006 17.242 -3.98645 -13.636 +1698 6 50.2756 39.8187 19.3535 -48.7732 -19.7782 -8.19609 +1699 4 50.1357 39.0812 19.9713 14.3147 6.83039 4.1366 +1700 4 49.4547 39.7468 18.7938 35.5854 8.27631 5.22634 +1701 6 3.57022 23.2982 26.3116 -7.21736 12.7853 -4.33091 +1702 4 3.04677 23.327 25.4841 2.15403 -9.28995 15.8001 +1703 4 3.1589 23.9918 26.8774 3.27351 -16.4313 -7.87876 +1704 6 43.3323 18.2357 20.5099 -9.76971 -1.121 -6.56922 +1705 4 42.7632 18.9863 20.7177 2.34101 2.93749 0.115163 +1706 4 43.9096 18.122 21.2711 1.48233 -4.92166 7.17918 +1707 6 14.4939 41.5272 19.7194 7.33174 -3.95938 -8.98841 +1708 4 13.9791 41.768 20.4704 -25.804 7.49044 14.4407 +1709 4 15.35 41.4773 20.1189 24.9681 -5.23262 -6.74673 +1710 6 29.2751 29.8624 26.915 55.5011 14.3278 -64.7852 +1711 4 29.462 29.6739 25.9095 -28.0317 9.76644 54.5148 +1712 4 30.1137 30.3565 27.1616 -29.5885 -20.0698 8.89328 +1713 6 6.32585 26.1455 11.5441 3.18215 15.5722 27.8672 +1714 4 6.22913 25.7559 12.4173 -5.87839 -9.43723 6.04013 +1715 4 6.88652 26.9071 11.7431 3.72153 0.148286 -16.8953 +1716 6 27.6581 9.23325 15.2376 24.6795 20.4415 1.81178 +1717 4 28.3906 9.86787 14.9946 -20.7277 -22.2866 6.02651 +1718 4 27.7257 8.49599 14.6233 3.42822 -3.8556 -2.27597 +1719 6 29.7826 38.0629 17.0951 -21.7625 -1.10982 -31.3954 +1720 4 29.5447 37.2807 16.5438 11.5646 7.7876 16.1146 +1721 4 29.1666 38.7512 16.7768 9.10566 -6.75007 12.2127 +1722 6 52.2237 28.7307 4.26632 40.7154 12.5569 -19.536 +1723 4 53.094 28.6942 3.75761 -25.982 6.02481 23.1744 +1724 4 51.8384 27.8718 4.17524 -3.40498 -27.0863 -4.04919 +1725 6 17.1651 16.6761 6.10093 10.0081 29.999 -15.4838 +1726 4 17.0645 17.5224 6.60658 -3.46995 -23.4179 -4.25622 +1727 4 16.9429 15.9406 6.65512 -3.52922 -13.7209 19.1007 +1728 6 36.6584 7.55275 33.426 1.51046 -27.4434 34.6673 +1729 4 36.0562 7.00422 33.9909 9.38132 12.247 -13.9906 +1730 4 36.0891 7.78594 32.7139 -15.8398 12.8789 -25.2624 +1731 6 26.1693 3.13272 9.58463 26.4836 36.1065 -53.3475 +1732 4 26.5189 3.61335 10.3026 12.8321 10.8542 33.1136 +1733 4 25.6805 2.43597 9.90138 -37.6231 -51.1462 30.1839 +1734 6 1.19232 17.1076 33.1734 0.722887 26.1228 -9.87087 +1735 4 1.0219 17.7977 32.4875 3.44775 -13.3597 11.6369 +1736 4 0.89275 17.4757 34.0242 -0.842403 -4.58413 -3.86686 +1737 6 29.175 10.1805 5.37687 2.48705 -7.47299 -1.58449 +1738 4 28.5307 10.3443 6.0806 2.54341 -1.49901 -0.102048 +1739 4 29.6529 9.35261 5.56356 -13.9845 3.47491 -0.693848 +1740 6 9.21964 21.135 0.193729 30.6013 -8.57211 -16.2038 +1741 4 9.93935 20.7152 41.5745 -5.21063 7.9265 20.924 +1742 4 8.4582 20.7874 41.6647 -18.4316 -1.36421 1.54976 +1743 6 7.41915 26.897 34.8578 6.273 24.0322 40.4596 +1744 4 7.07209 27.1094 35.7714 11.2799 -9.18849 -34.7736 +1745 4 6.87885 26.1925 34.5434 -18.5272 -22.724 -11.5995 +1746 6 18.6237 10.1563 3.02822 -55.9716 37.9013 1.68891 +1747 4 17.9823 9.44023 2.87563 14.9297 4.34306 1.98909 +1748 4 18.009 10.9755 3.18254 40.8652 -32.8317 -2.61569 +1749 6 13.1455 21.2337 25.2154 -14.3081 5.93545 -14.9534 +1750 4 12.8153 21.6822 24.4216 9.6722 -4.26313 4.93127 +1751 4 12.7862 20.3541 25.1726 -3.49479 -14.4912 -0.313259 +1752 6 4.91031 24.4198 40.532 -13.7809 -26.5024 -53.169 +1753 4 5.65778 24.4539 41.0894 26.3299 12.2697 26.6549 +1754 4 5.26856 23.9753 39.7091 -18.4358 16.5303 24.5031 +1755 6 54.7198 6.2862 9.93073 18.558 2.67796 -18.7732 +1756 4 54.1336 6.00192 10.611 -15.308 -5.80798 23.6242 +1757 4 0.005563 7.17106 10.1764 0.43073 7.36928 5.10877 +1758 6 51.7604 16.6436 19.3877 -20.3234 -7.55047 -14.8495 +1759 4 51.6779 16.1639 18.5383 1.1676 14.9854 4.84802 +1760 4 52.2077 17.4816 19.2574 16.3674 3.30585 -9.00164 +1761 6 38.6218 2.96001 13.0988 15.7387 3.67705 55.5859 +1762 4 38.6299 3.43096 13.9849 -4.06073 -12.9308 -23.724 +1763 4 38.2169 3.56793 12.5083 -12.8186 19.7945 -24.9943 +1764 6 19.4471 35.7007 9.61167 2.35324 -8.95281 6.35471 +1765 4 18.8335 36.2871 9.19379 -17.9936 2.63552 -14.7984 +1766 4 18.9495 35.3837 10.3842 8.56204 6.47345 -9.11173 +1767 6 46.9457 37.6212 25.7021 -15.6754 4.57489 10.5165 +1768 4 47.0239 38.0262 24.8354 11.6036 -0.197794 -10.4287 +1769 4 47.7281 37.1166 25.9279 8.14222 -0.129186 -6.11913 +1770 6 20.0249 17.2708 14.7582 9.34392 -2.11639 -6.02108 +1771 4 19.1723 17.4786 15.1706 12.7461 -0.873648 3.80655 +1772 4 20.7009 17.0069 15.4035 -13.3418 2.74043 0.572405 +1773 6 24.7358 29.2923 3.78206 18.5642 -33.4808 -47.1325 +1774 4 24.7422 28.3915 3.3709 -13.1038 11.8323 28.3161 +1775 4 25.3506 29.6775 3.14782 -2.77927 21.1078 10.4189 +1776 6 3.43141 8.92567 6.82668 25.8011 -1.75535 29.9445 +1777 4 3.08486 8.82716 7.75964 16.0017 4.22665 -30.6726 +1778 4 4.42441 9.10783 6.89545 -42.5611 -5.30748 1.54274 +1779 6 17.4891 30.59 19.7026 37.1524 -11.5388 -6.241 +1780 4 18.4343 30.3591 19.4199 -38.2372 10.1448 10.4771 +1781 4 16.9657 29.7875 19.5831 -4.14236 3.18225 -9.29444 +1782 6 13.2748 16.1833 39.0603 8.39615 -10.6604 2.01333 +1783 4 13.778 16.9491 39.3364 8.93523 3.59341 7.63718 +1784 4 12.5498 16.5465 38.5646 -17.693 7.52452 -10.3405 +1785 6 23.8419 27.9652 11.5971 -29.0622 15.8949 5.8355 +1786 4 23.0433 27.5239 11.9581 15.8216 -1.64981 -8.50246 +1787 4 23.6687 28.8945 11.8451 9.38175 -9.8305 -3.59643 +1788 6 14.4582 24.411 21.2251 -13.2323 27.0215 19.0701 +1789 4 13.9163 25.2229 21.3861 13.2503 -9.35589 -12.2275 +1790 4 14.348 23.9323 22.0593 -1.27999 -3.95586 -5.82862 +1791 6 46.6209 15.1404 22.2877 -21.0909 8.30909 34.5316 +1792 4 45.8336 14.7024 21.9608 7.3328 -3.88381 -14.3297 +1793 4 47.2246 15.4169 21.6106 10.5055 -5.27886 -22.0515 +1794 6 19.1453 29.7169 11.8746 -27.0123 -18.8736 -35.9167 +1795 4 18.7667 30.5363 11.5796 10.8323 29.6783 4.39578 +1796 4 18.5214 29.1838 11.3275 23.3568 -13.7991 20.8336 +1797 6 36.9132 18.8016 27.615 -17.0652 -23.8487 30.8874 +1798 4 36.4034 18.4868 26.8464 6.26881 1.65463 6.80847 +1799 4 36.6041 18.1666 28.3506 10.215 31.7365 -33.4968 +1800 6 35.8839 17.5137 25.5036 -5.81764 30.7264 -16.7466 +1801 4 36.5665 17.9094 24.9 -10.7703 -22.5287 9.19997 +1802 4 35.9135 16.5474 25.44 8.68204 5.15754 -2.43364 +1803 6 8.04468 41.8981 31.5366 26.4021 9.77217 -3.38911 +1804 4 8.66886 41.284 31.9946 -24.4733 15.0027 -13.0466 +1805 4 8.60227 0.704634 31.1522 -11.4596 -14.2431 6.13083 +1806 6 31.7024 34.8356 17.9299 26.5575 -27.0845 -4.88708 +1807 4 32.6196 34.4986 17.7931 -22.3662 0.836155 -3.84042 +1808 4 31.9071 35.6664 18.3392 -5.09232 26.8034 6.09861 +1809 6 22.0993 41.0535 5.13739 10.0927 40.3608 -89.4928 +1810 4 22.1435 40.6782 5.94278 2.96748 -46.7441 88.004 +1811 4 22.8097 40.6452 4.60918 -8.49191 2.25551 6.5005 +1812 6 11.6188 5.17183 29.5438 -37.4391 -17.3681 45.4318 +1813 4 12.0782 4.3477 29.7115 12.4576 1.56532 -11.0695 +1814 4 10.8376 5.06958 30.1835 21.3256 14.0691 -33.8944 +1815 6 13.0142 9.45267 21.0738 -17.3871 -39.5803 -33.4019 +1816 4 13.648 9.91302 21.5572 37.1542 33.3127 26.6408 +1817 4 13.4951 8.71823 20.6397 -14.9934 11.5246 2.17133 +1818 6 12.4259 4.16416 0.171584 25.5917 58.0572 -18.9009 +1819 4 12.7038 3.75631 0.988868 -0.121161 -3.62646 8.37405 +1820 4 12.9914 5.02921 0.073462 -27.1162 -49.1387 2.0493 +1821 6 45.1548 14.6294 28.1056 43.5869 -15.7342 -2.79686 +1822 4 45.3799 14.9442 27.2254 -14.4652 2.82802 -6.08545 +1823 4 46.001 14.1543 28.294 -26.1128 6.03561 5.66217 +1824 6 52.5819 19.2522 0.880939 -13.6546 -24.4625 3.21793 +1825 4 52.4967 19.3157 41.8353 6.16951 -6.72877 -2.3034 +1826 4 52.7342 20.1258 1.1855 8.55196 28.2584 6.16427 +1827 6 0.17636 18.5769 30.5692 -13.5341 -21.3209 11.3545 +1828 4 0.97347 18.6538 30.0344 3.16555 8.74201 -0.550561 +1829 4 54.7381 19.4288 30.6755 1.51483 11.9419 -1.05075 +1830 6 17.6474 28.1849 1.96582 -3.95698 7.79984 2.09024 +1831 4 17.0036 28.8884 1.72628 7.01161 -11.1903 7.18073 +1832 4 17.5665 28.0879 2.93205 1.48476 5.36119 -8.9874 +1833 6 22.5179 30.1562 5.01973 -0.557011 13.5756 -11.2394 +1834 4 23.053 30.1464 4.21842 7.71181 1.56353 5.86697 +1835 4 22.1417 29.2826 4.9966 -11.5089 -8.75783 6.0437 +1836 6 11.3992 8.80614 17.6425 18.8049 17.2909 -5.92301 +1837 4 12.0044 8.1818 18.0403 -8.94801 -14.7479 17.6102 +1838 4 12.0653 9.44286 17.3244 -18.8797 1.15675 -4.46111 +1839 6 32.2825 3.5901 26.8335 38.6865 42.7422 0.354813 +1840 4 31.9744 3.38447 25.9652 -16.937 -9.17442 -22.5821 +1841 4 32.8531 4.41036 26.697 -18.7333 -32.0278 -1.10411 +1842 6 26.8283 37.1448 15.664 9.9544 44.9512 -6.81835 +1843 4 26.832 37.6522 16.5019 -4.80771 -22.2764 -7.00776 +1844 4 26.708 36.2069 15.7377 -4.77442 -21.1488 11.5765 +1845 6 22.9466 3.40402 22.281 26.551 -3.46013 -1.27592 +1846 4 23.3626 3.00539 21.4748 -15.0613 6.75 14.6032 +1847 4 23.702 3.67884 22.8406 -14.5661 -4.86975 -12.1571 +1848 6 14.6187 28.2219 5.2011 12.2375 -1.31522 5.54773 +1849 4 14.146 28.1316 4.37141 -5.71124 1.87741 -8.30492 +1850 4 14.2863 29.0052 5.66137 -0.824291 -0.470469 -2.06805 +1851 6 20.2555 37.1856 16.5486 -24.9193 16.4856 21.7008 +1852 4 21.0596 37.4718 16.144 26.6499 6.5165 -11.4453 +1853 4 20.1477 37.8155 17.2956 -4.48599 -12.7862 -6.90992 +1854 6 17.9469 28.5629 23.8891 26.0841 -15.2841 -12.8531 +1855 4 18.7956 28.2639 23.4837 -20.5944 5.95667 14.8805 +1856 4 17.3322 27.8283 23.7208 -3.07308 9.52654 -1.59768 +1857 6 33.6454 24.2344 25.2281 6.08515 -19.3492 9.67379 +1858 4 33.7229 23.2583 25.1621 -7.7165 13.5894 -11.682 +1859 4 33.9838 24.3464 26.1231 0.527101 9.69022 -3.14208 +1860 6 9.99248 17.6305 2.22889 -2.94775 -31.1618 -12.577 +1861 4 10.7668 17.5307 1.6348 -7.17319 1.58445 12.7603 +1862 4 9.8062 16.7546 2.64219 6.61617 15.6433 -4.64734 +1863 6 24.3378 36.7975 8.92134 10.0949 -17.5556 18.6285 +1864 4 24.0798 37.5812 8.46711 -7.4438 24.0622 -5.98172 +1865 4 24.7733 37.0584 9.7453 -6.84359 -4.10885 -5.58351 +1866 6 14.3929 4.30304 27.7402 56.7365 -3.53996 19.7179 +1867 4 15.3546 4.44499 27.4586 -37.3153 -7.57895 7.00929 +1868 4 13.8272 4.37832 26.9899 -16.116 5.01688 -19.8092 +1869 6 13.2096 25.4586 35.3298 -3.87145 -6.51473 -10.8119 +1870 4 13.1476 25.2267 36.278 -1.83966 -3.78777 -13.8323 +1871 4 12.5545 24.9939 34.7684 5.09589 5.85633 19.2997 +1872 6 43.7315 33.1816 24.4051 17.2004 -9.02075 24.8986 +1873 4 44.3591 33.0681 25.1678 -20.1541 -6.26738 -17.3644 +1874 4 44.1096 33.9146 23.9227 -1.6352 8.32092 -8.69406 +1875 6 6.97009 30.4077 7.13769 23.121 1.43384 34.0809 +1876 4 6.71282 29.9591 7.9596 7.06976 3.62274 -2.26904 +1877 4 6.20421 30.2819 6.61977 -27.9511 -2.76807 -27.2062 +1878 6 44.437 39.4145 21.7835 -9.43682 11.6365 -18.5611 +1879 4 43.878 39.1032 21.0489 1.92512 -11.9494 17.5009 +1880 4 44.878 40.1639 21.3648 8.44417 -6.89071 6.17346 +1881 6 1.1648 16.4475 24.9778 -2.61131 5.39938 13.1681 +1882 4 1.07525 17.0286 24.1819 -7.88043 -13.0173 22.3573 +1883 4 0.434843 16.5677 25.6378 18.4556 1.9359 -28.7216 +1884 6 8.16988 33.8361 10.6637 16.6829 23.9256 47.7562 +1885 4 8.49559 33.5478 9.83195 -4.50358 -22.2449 -29.7436 +1886 4 7.35799 33.4028 10.9227 -18.4601 -13.1254 -8.86092 +1887 6 45.3716 15.8699 40.491 -6.36942 -3.03704 -2.15917 +1888 4 44.5133 15.7719 40.0601 4.63234 -6.98635 -0.416374 +1889 4 45.243 16.6248 41.0649 5.7116 1.92459 5.42472 +1890 6 38.7776 4.29245 15.9056 11.0795 0.30753 4.41463 +1891 4 39.6766 4.00679 16.0952 1.69097 -2.92337 -3.33067 +1892 4 38.5504 4.73291 16.7401 -7.14778 -2.92142 -9.36231 +1893 6 21.0846 9.20759 23.9691 5.60032 -0.18462 4.18544 +1894 4 20.9445 8.65571 23.1711 -3.69603 16.8592 7.46004 +1895 4 20.5672 10.0363 23.9442 1.93643 -14.5945 -11.3561 +1896 6 6.46938 36.1391 20.0069 4.0004 4.10087 4.13062 +1897 4 5.99357 35.3124 19.8297 -2.3473 7.0562 -2.30419 +1898 4 7.3052 35.893 20.4098 -0.600933 -5.92452 -3.30983 +1899 6 17.7588 23.4635 11.2444 16.528 -28.2646 53.7307 +1900 4 16.9432 23.8548 11.0264 -32.805 26.4079 -23.7501 +1901 4 17.621 23.3206 12.2167 9.32529 -0.814156 -28.2078 +1902 6 2.23938 39.2705 23.5372 32.4488 -19.3396 -21.3039 +1903 4 2.96143 39.1072 24.212 -19.8533 -4.03587 -26.9428 +1904 4 2.57592 39.0525 22.6024 -11.4643 11.6849 46.2914 +1905 6 21.7189 10.3135 3.08585 -2.90529 19.7604 61.578 +1906 4 21.843 10.1221 2.19424 -0.974385 -17.6276 -55.1642 +1907 4 20.7734 10.4085 3.28686 2.80557 -4.86174 -11.6796 +1908 6 13.3371 37.6485 26.8148 34.7445 -2.08205 -3.58175 +1909 4 12.7942 37.01 27.2655 -5.666 -15.7112 8.11946 +1910 4 14.1995 37.1812 26.5945 -31.1056 12.6209 6.4215 +1911 6 45.679 9.86525 8.82671 -1.22844 -5.97168 -0.0165319 +1912 4 45.3204 9.57969 7.98479 1.29945 7.51218 -9.52666 +1913 4 45.2548 9.27624 9.44517 -6.37871 -3.09075 9.62419 +1914 6 39.8117 32.343 29.5858 -3.04799 14.0722 -9.88422 +1915 4 39.6223 31.4471 29.2796 3.58631 -7.81261 7.71305 +1916 4 40.3439 32.3214 30.3816 0.770365 -10.1242 2.16071 +1917 6 39.1301 32.1592 8.96473 45.9624 -7.76569 -23.2306 +1918 4 39.6852 32.0596 8.1252 -31.4186 4.60772 35.1501 +1919 4 38.2007 32.2042 8.75798 -9.66602 0.778467 -8.76952 +1920 6 29.7501 11.3103 40.3404 42.6438 -12.6008 -10.1865 +1921 4 29.0692 10.6634 40.5326 -1.99158 -8.72077 -0.363163 +1922 4 30.6164 10.7842 40.3158 -34.6338 15.486 -0.0451708 +1923 6 24.8345 19.8801 29.8412 -7.59088 37.7695 16.0848 +1924 4 24.9026 19.0378 30.268 -1.65451 -21.4471 9.48031 +1925 4 24.5694 20.5293 30.547 8.64688 -23.6335 -15.2845 +1926 6 50.0799 29.4689 2.86832 11.3398 7.37373 -14.0975 +1927 4 50.7937 29.3382 3.51213 -5.95266 6.62042 -8.33887 +1928 4 50.5172 29.4209 1.98721 -16.9062 -3.16045 21.5768 +1929 6 26.3158 13.2487 37.9516 44.6834 6.62304 1.7852 +1930 4 27.2667 13.2121 37.7291 -19.4356 -10.4808 -19.3263 +1931 4 26.4654 13.336 38.8817 -25.2145 10.5198 25.1195 +1932 6 24.3285 13.817 16.1492 -2.87417 -29.0242 -9.8062 +1933 4 24.8278 14.0306 16.9324 2.95884 13.8503 11.1204 +1934 4 24.1796 14.5912 15.6032 1.91347 13.6823 2.96602 +1935 6 21.9624 25.0824 8.00452 15.4008 12.078 14.6814 +1936 4 22.598 25.7039 7.58094 -6.50256 -15.9793 3.04336 +1937 4 22.4506 24.6482 8.74092 -7.92214 9.81208 -17.5113 +1938 6 50.1646 25.295 29.0323 7.20414 -13.325 -13.2678 +1939 4 50.9752 25.188 28.522 -3.46618 -9.57224 -11.582 +1940 4 50.4808 25.9292 29.6536 -4.58067 20.151 23.6328 +1941 6 23.186 6.81871 7.63171 8.52809 43.4321 -4.70249 +1942 4 24.005 7.36604 7.81791 -26.2659 -19.6382 -4.15731 +1943 4 22.4749 7.49932 7.50679 12.9101 -23.886 0.0924589 +1944 6 6.93738 5.85096 20.8328 -1.25739 23.0019 -5.42089 +1945 4 7.49016 6.65136 20.6793 -8.05782 -22.0664 2.33926 +1946 4 6.43567 5.73489 20.0135 6.68134 -11.6114 -0.0369962 +1947 6 25.4027 39.7503 23.9523 -6.31967 32.2782 -31.5462 +1948 4 25.6215 38.8259 24.0292 3.86532 -10.8289 -5.32001 +1949 4 25.5293 40.0494 22.9984 1.78505 -20.5244 33.6821 +1950 6 10.8465 30.682 2.12076 -14.9417 -4.95607 29.3443 +1951 4 9.91334 30.8811 2.27771 3.65307 -4.25506 9.47201 +1952 4 11.0492 31.2188 1.38489 10.4343 12.2811 -36.8692 +1953 6 23.0846 40.5263 40.0577 -14.1833 12.856 -13.2149 +1954 4 23.7732 40.7716 39.4116 -4.4893 -4.99974 3.24897 +1955 4 22.2685 41.0049 39.7737 14.5189 -12.3092 -2.05606 +1956 6 29.2062 28.3669 37.5673 -46.9973 46.4688 -26.4511 +1957 4 28.2092 28.447 37.3765 47.4284 -5.55714 9.99444 +1958 4 29.3363 27.5265 37.9547 9.31284 -31.0764 15.334 +1959 6 1.86163 12.1711 18.0765 -5.91003 5.49035 -5.71632 +1960 4 2.55659 11.9166 18.6527 25.6221 -14.4574 8.12849 +1961 4 1.26079 12.5379 18.7153 -20.6967 6.08864 -3.03965 +1962 6 35.8475 14.1052 8.57203 -21.6385 -0.893463 -33.3774 +1963 4 35.1968 13.4152 8.63145 -9.00219 -13.9675 31.2536 +1964 4 35.5915 14.3843 7.67264 23.8052 12.2531 2.11843 +1965 6 9.47935 39.8135 37.5891 59.0759 6.31763 -30.1219 +1966 4 10.4266 39.6693 37.2666 -35.8633 -8.68454 26.4626 +1967 4 9.26489 40.5592 37.0217 -20.4655 -4.29881 5.22341 +1968 6 3.55142 30.3339 19.2713 -4.86381 -1.52132 15.3498 +1969 4 4.33638 30.9045 19.2209 2.57405 -7.87202 3.73908 +1970 4 3.61239 29.7873 20.0935 6.99099 14.0083 -17.3235 +1971 6 36.3358 32.3745 17.56 -88.747 -21.2483 -18.3477 +1972 4 37.1123 32.7301 17.855 71.5568 29.0637 22.2427 +1973 4 36.4955 31.7908 16.8209 7.92507 -6.87638 -5.35096 +1974 6 22.0663 24.5107 41.4102 10.2987 16.3962 12.7497 +1975 4 21.8202 25.2352 0.099599 7.35269 -2.74787 -1.24985 +1976 4 21.4331 24.5495 40.7007 -15.7672 -0.145359 -12.6123 +1977 6 45.7559 15.6146 11.6534 9.54961 -0.52573 -11.8143 +1978 4 46.6616 15.9476 11.7359 -2.85604 3.39399 3.95489 +1979 4 45.8337 14.6574 11.6049 5.18085 -12.4794 -2.56515 +1980 6 22.3677 20.3608 16.0248 -8.43349 0.762232 -3.33301 +1981 4 21.8453 20.4382 16.8206 -16.1556 -9.64869 10.2413 +1982 4 23.0114 21.0388 16.1556 20.3116 20.3082 3.24798 +1983 6 25.8272 25.7408 18.9039 -4.38174 23.1082 -8.64826 +1984 4 25.2526 26.4897 18.6396 10.1677 -11.9346 2.39614 +1985 4 25.327 25.3554 19.6213 -1.60311 -10.6753 3.35926 +1986 6 35.3217 34.2027 33.2895 -15.2368 -41.9721 4.95923 +1987 4 35.4982 35.1152 33.2737 3.10328 43.0158 -1.14622 +1988 4 34.4946 34.1251 33.8 0.780353 -3.85018 -10.6306 +1989 6 39.2773 17.1161 17.3873 -13.1248 -32.2738 -8.05101 +1990 4 39.9918 17.6798 17.5739 28.094 23.6652 8.23643 +1991 4 38.688 17.6273 16.829 -11.1713 3.07886 5.75329 +1992 6 0.390078 14.9382 21.7871 11.1367 4.76555 -0.935352 +1993 4 54.4387 14.8735 21.5807 -4.47162 2.48431 -1.07762 +1994 4 0.539841 14.2564 22.4568 -0.558284 -6.24417 -4.29591 +1995 6 15.9777 23.2264 17.7728 8.65625 13.1041 -6.34263 +1996 4 15.4566 22.9884 16.9791 5.52796 1.00784 5.82867 +1997 4 16.2806 24.159 17.6616 -10.6082 -13.1932 5.11686 +1998 6 5.23931 11.1231 17.5575 35.8701 -10.5445 17.9772 +1999 4 4.9182 10.2425 17.6538 -30.0926 -10.858 -8.95801 +2000 4 6.0864 10.9521 18.0214 -7.64643 27.0942 -5.06777 +2001 6 9.32885 36.7248 13.2722 18.9931 -22.2768 -8.23823 +2002 4 9.60165 35.7781 13.2295 -3.69965 14.6724 -0.704445 +2003 4 9.76236 37.1699 12.5317 -7.58045 -2.70049 0.515103 +2004 6 25.4778 33.5648 0.584885 -10.5355 67.2754 -12.4068 +2005 4 25.5984 34.5208 0.879361 -11.6997 -30.6233 -9.64051 +2006 4 26.086 33.1118 1.1181 20.4991 -31.2317 29.3626 +2007 6 17.3118 24.383 31.3319 -1.28664 6.54307 -2.76395 +2008 4 17.7194 25.1777 30.9449 -5.40799 -4.17061 0.343513 +2009 4 16.6541 24.6578 31.9842 -4.89885 3.77294 -0.581941 +2010 6 50.5608 32.7082 27.7934 4.54158 -2.94952 -18.7634 +2011 4 50.7453 32.9177 28.6973 0.494052 11.2961 18.8161 +2012 4 49.6536 32.9735 27.676 -15.0266 -0.0998574 -2.84245 +2013 6 2.26734 37.236 16.1173 -6.42813 -12.7591 -21.9136 +2014 4 3.23226 37.3187 16.1136 -7.03488 -2.64717 4.42174 +2015 4 1.90002 37.4962 16.9584 8.86323 8.39289 12.7736 +2016 6 25.781 33.1953 8.40059 -29.5389 -21.3471 9.61313 +2017 4 24.912 33.1588 8.86731 13.6407 4.32372 -10.5279 +2018 4 25.7521 32.4014 7.84509 3.14784 4.30114 -1.53431 +2019 6 24.7803 7.83271 25.42 33.5144 32.018 13.9598 +2020 4 25.5535 8.29724 25.0002 -28.4293 -10.6828 16.5011 +2021 4 24.3491 7.42211 24.7041 -24.9556 -17.4551 -27.4815 +2022 6 44.0168 27.3303 21.5604 -2.1935 -26.0293 -25.9567 +2023 4 43.1804 27.7287 21.7105 -15.5436 25.6402 11.6584 +2024 4 43.7182 26.5374 21.0766 16.4483 6.01939 6.04345 +2025 6 20.8314 32.075 6.72772 34.1297 -23.9008 -4.85338 +2026 4 21.613 31.4679 6.7544 -19.7741 14.5872 -14.4381 +2027 4 20.6476 32.1788 7.6576 -7.69651 14.1485 11.3249 +2028 6 0.619789 26.0994 3.99415 -10.3518 14.1264 10.767 +2029 4 0.887335 25.4928 3.30986 5.36048 -13.1936 -7.97543 +2030 4 1.24971 25.9998 4.71308 0.85353 -1.82089 -1.56654 +2031 6 23.69 0.227417 22.8544 35.0871 1.11343 17.3571 +2032 4 23.3906 1.11513 23.0752 -8.28129 -2.57498 -6.74336 +2033 4 24.6181 0.214091 23.2237 -29.0994 -2.98435 -11.3486 +2034 6 35.6339 26.9438 6.46453 10.8918 50.3879 3.14258 +2035 4 36.2586 27.0344 7.19591 -3.09793 -24.7425 -0.485193 +2036 4 35.6905 27.8753 6.10871 -13.1004 -35.3011 6.52721 +2037 6 50.1792 7.09321 18.6927 -10.3798 0.485236 0.91939 +2038 4 50.7755 7.39768 17.9917 2.23399 -7.26744 -1.07457 +2039 4 49.6856 7.89728 18.8977 2.66313 1.30029 -2.34319 +2040 6 12.4725 14.8259 12.1994 -11.4238 -12.6169 14.8051 +2041 4 11.6664 14.488 12.6556 18.5487 5.78377 -7.93059 +2042 4 12.1518 15.362 11.4889 -6.75978 6.85562 -13.2996 +2043 6 52.4644 22.357 36.3266 1.29806 9.96622 10.4358 +2044 4 51.6029 21.898 36.3064 11.3287 0.910024 -15.7837 +2045 4 53.0734 22.0059 35.6434 -17.6122 -2.36697 5.80151 +2046 6 41.7741 11.4843 39.1248 -4.39753 -8.31887 -97.8346 +2047 4 42.1028 11.6824 39.9378 27.3537 17.7413 77.2645 +2048 4 42.4804 11.7867 38.4877 -22.5072 -9.73773 16.9601 +2049 6 13.8016 22.5118 39.1095 -61.9889 -17.7515 -30.6487 +2050 4 12.8197 22.2903 39.2632 45.6803 12.2331 1.0283 +2051 4 13.898 22.318 38.1378 10.5436 5.15112 27.5343 +2052 6 28.757 19.5278 21.8422 22.1809 -34.574 6.30338 +2053 4 29.5381 18.8977 21.7155 -30.335 22.4331 6.48321 +2054 4 28.5907 19.9346 20.9925 4.65837 4.37905 -10.6157 +2055 6 8.3499 21.6369 36.3971 -4.18721 -6.14707 -6.4426 +2056 4 8.67403 22.5346 36.3601 -3.60933 11.4321 4.1017 +2057 4 7.70004 21.5677 37.1222 1.54916 7.87236 -6.53046 +2058 6 39.9526 23.9745 15.2115 13.6309 -13.3423 -31.903 +2059 4 40.8439 23.5703 15.3899 -24.3155 14.8143 -11.3375 +2060 4 39.7878 23.9253 14.2154 4.70535 3.62281 36.021 +2061 6 8.1527 38.6897 22.5283 9.69445 13.3876 41.2978 +2062 4 7.76273 39.4363 22.0797 -11.7526 5.15604 -12.9046 +2063 4 8.4358 39.1168 23.3873 -5.25998 -17.8667 -18.7912 +2064 6 10.8496 20.1728 28.9641 16.4592 -1.26099 15.6701 +2065 4 9.98954 19.7606 29.0198 -7.88942 -4.93169 1.40711 +2066 4 10.9743 20.477 28.0788 -3.54014 6.836 -18.3013 +2067 6 36.8958 23.8215 41.8184 -11.2791 50.4956 -15.8947 +2068 4 37.6092 23.2626 0.106032 31.5333 -36.7229 14.8491 +2069 4 36.0533 23.398 41.8576 -15.1401 -19.7994 6.87638 +2070 6 23.7844 40.6753 33.3645 25.4398 -8.90266 -26.6636 +2071 4 23.0047 40.9559 33.8219 -17.4738 3.31201 10.6553 +2072 4 23.8864 39.707 33.5122 -4.88896 17.7845 5.86364 +2073 6 4.67086 19.2968 35.4027 23.2175 14.2952 24.1117 +2074 4 5.52557 19.1329 35.8895 -25.1286 -0.194605 -14.6261 +2075 4 4.47498 18.5363 34.8535 5.06934 -11.7578 -4.1199 +2076 6 9.45318 25.7818 10.8943 -12.0967 -8.54473 -2.48434 +2077 4 9.17249 24.8577 10.8042 5.18757 -1.88658 7.00696 +2078 4 8.69489 26.2739 10.5541 4.04726 3.8113 4.64502 +2079 6 27.2856 22.4903 13.6084 -4.27813 -9.26261 -11.4963 +2080 4 27.1477 21.7546 14.2243 0.799228 0.372191 -1.31996 +2081 4 27.4324 22.0688 12.7356 2.14896 10.5831 15.5277 +2082 6 41.0369 18.7679 23.2817 21.3973 -17.1333 -11.6606 +2083 4 40.4805 18.1775 22.7581 -1.93352 7.79722 7.02989 +2084 4 40.5302 19.4817 23.6332 -16.07 12.1618 6.58845 +2085 6 46.4867 28.3511 20.139 19.5633 -2.73425 79.1757 +2086 4 45.7489 28.0125 20.7058 1.11057 9.83041 -23.9354 +2087 4 47.2126 28.3766 20.859 -22.6454 6.05643 -47.0217 +2088 6 14.8422 15.3983 30.0672 9.57922 -13.7488 21.5316 +2089 4 14.7114 15.4303 29.1407 -5.18406 2.12307 -31.6519 +2090 4 14.4223 14.5569 30.327 1.67929 11.6926 7.32181 +2091 6 23.5155 24.7614 35.2027 10.8097 10.1661 11.7756 +2092 4 22.8249 25.3921 35.4883 8.74662 -8.07224 -2.50931 +2093 4 24.264 24.8574 35.8273 -14.1502 1.20627 0.95778 +2094 6 19.9045 24.2066 28.4368 -7.08314 38.6572 -15.5481 +2095 4 20.1199 25.09 27.9887 -7.53461 -31.417 18.3002 +2096 4 18.948 24.2479 28.615 8.77669 -1.27719 -1.90381 +2097 6 45.9703 7.63062 20.2339 -9.12647 -14.8446 45.7383 +2098 4 46.0314 7.87281 21.2057 4.66889 -10.1155 -32.2433 +2099 4 46.2124 8.39508 19.7344 6.23892 21.3693 -9.48098 +2100 6 38.0366 12.4686 8.28298 -82.8488 23.4696 -21.0017 +2101 4 37.3097 13.1608 8.47894 48.7672 -25.4087 1.47773 +2102 4 37.4891 11.9231 7.63396 42.6716 2.94367 19.7224 +2103 6 46.9352 18.181 8.45984 -29.3266 9.95329 16.0714 +2104 4 46.1825 17.5598 8.49993 9.84889 1.25457 2.04897 +2105 4 47.3911 17.9594 7.65971 14.7535 -7.6497 -21.4463 +2106 6 10.8592 13.9727 9.37152 -3.14543 -2.30259 -2.26695 +2107 4 10.3309 14.6626 8.91794 11.6563 -8.1882 2.6931 +2108 4 11.7607 13.9013 8.99546 -12.5287 13.781 2.06755 +2109 6 34.3902 5.43491 14.0826 12.6346 -17.837 -1.14204 +2110 4 35.1666 5.80709 13.6695 9.45544 21.1547 -1.41353 +2111 4 34.3397 4.58795 13.6148 -10.7305 -5.41844 9.88093 +2112 6 0.19016 0.223418 22.9526 3.77382 -24.7853 -3.01602 +2113 4 0.21308 41.6498 22.1069 2.59646 7.80057 12.2766 +2114 4 54.882 1.08863 22.7473 -12.4607 27.7599 -7.08256 +2115 6 40.9349 30.5562 37.8906 -27.573 -19.5948 34.9696 +2116 4 40.0494 30.8463 38.2359 23.4276 0.414778 -20.0189 +2117 4 41.1198 29.7844 38.4793 13.2677 19.1991 -19.1849 +2118 6 16.6358 17.3088 12.6818 26.7235 26.3695 -9.20965 +2119 4 16.2617 16.4703 12.4231 -8.92935 -8.7699 -0.695474 +2120 4 17.0088 17.6771 11.8494 -7.35458 -7.68048 15.4997 +2121 6 29.681 5.43286 24.7605 9.99716 1.48249 -7.0405 +2122 4 30.3348 5.91815 24.2382 -0.696307 0.629534 -2.6419 +2123 4 30.0075 5.55596 25.6632 -4.07672 -1.78023 1.29455 +2124 6 49.8902 0.287541 27.2058 21.9743 -13.7053 4.20571 +2125 4 49.8511 0.519591 26.2742 -5.37584 5.48457 -4.26768 +2126 4 50.7946 41.8257 27.2858 -12.157 4.98657 1.57708 +2127 6 31.2412 31.7366 15.2127 13.4193 29.9729 -4.01619 +2128 4 31.644 30.8863 15.3566 3.05611 -13.2507 6.82249 +2129 4 31.9953 32.37 15.1128 -22.0385 -12.9049 3.52444 +2130 6 35.7903 24.1511 16.9464 13.6459 1.10276 -6.74723 +2131 4 35.6731 24.9832 16.4455 1.01595 -13.8109 1.97492 +2132 4 36.7089 23.8312 16.7527 -22.9866 2.97508 8.81266 +2133 6 24.2751 4.63968 36.7374 -16.5997 -22.3051 -33.4925 +2134 4 24.7608 5.22686 37.2962 14.6544 10.0168 10.4919 +2135 4 24.7016 4.68474 35.8573 -7.94113 -0.389021 16.9181 +2136 6 17.5636 12.9031 3.65869 27.6744 1.86844 -28.0383 +2137 4 17.6858 13.5605 2.94059 1.9993 -16.4932 11.4828 +2138 4 16.8984 13.3068 4.18363 -27.8054 1.98581 18.3397 +2139 6 4.17446 14.2934 18.2709 12.2351 -24.5699 -15.5283 +2140 4 4.25201 13.3082 18.1842 -5.45348 23.7329 4.34334 +2141 4 3.28482 14.5076 18.5604 -13.4286 -3.54266 5.37394 +2142 6 19.1793 36.8557 22.3908 -6.26797 4.12828 -2.16449 +2143 4 18.7803 36.3059 23.064 -4.74301 -7.71326 18.3965 +2144 4 19.5341 36.2254 21.7686 7.87239 -11.0625 -9.31555 +2145 6 15.659 11.9578 13.1999 9.98626 24.0921 3.91449 +2146 4 15.6233 12.8387 12.7526 3.08695 -23.3335 12.0049 +2147 4 16.532 11.8904 13.6603 -13.5492 -1.68197 -15.0215 +2148 6 24.7583 21.9129 5.36621 -52.0449 4.43235 28.4012 +2149 4 24.9756 21.6947 6.28233 10.5491 3.37037 -1.58044 +2150 4 23.7611 21.9216 5.43181 35.5612 -5.35731 -13.8865 +2151 6 52.741 18.5708 35.2268 19.1809 2.02674 5.12186 +2152 4 52.5591 18.101 34.4104 -23.468 -7.47943 -3.72799 +2153 4 51.9957 18.6447 35.8177 -20.5936 -5.49273 0.0575333 +2154 6 3.56038 27.2788 25.2921 -16.6903 -17.6792 -11.4043 +2155 4 3.96469 27.2185 26.149 7.10467 -3.13705 18.347 +2156 4 3.97939 27.9962 24.8424 10.8751 21.6711 -8.62461 +2157 6 34.4448 32.9974 30.68 48.2331 9.00339 -1.41906 +2158 4 33.5189 32.8245 30.8394 -9.09046 9.48004 8.12592 +2159 4 34.8804 33.6211 31.3233 -29.3839 -17.782 -5.29467 +2160 6 35.2611 23.7526 9.83248 5.28039 9.63542 14.9856 +2161 4 34.4624 23.9143 9.32096 3.45609 1.41047 -6.97204 +2162 4 35.624 22.9154 9.5528 3.26088 -11.8232 -8.34585 +2163 6 42.4243 15.7233 8.97763 12.8326 1.39623 12.6931 +2164 4 41.658 15.328 8.60072 -22.8346 -8.994 -22.1277 +2165 4 42.104 15.9534 9.85586 1.77226 3.68974 5.84069 +2166 6 7.76866 28.8533 32.9548 -11.0049 17.2013 -15.4709 +2167 4 8.04862 28.1203 33.4848 1.42969 -15.0059 16.0601 +2168 4 8.50079 29.0495 32.3677 8.58058 4.20069 -3.59376 +2169 6 17.6953 41.2515 36.4663 -11.3067 -18.3758 74.5383 +2170 4 16.8889 41.7296 36.6796 -1.19906 6.43806 -6.60961 +2171 4 17.8689 41.3412 35.574 12.2332 11.1792 -57.8962 +2172 6 28.5157 24.2416 15.5518 -29.4686 -13.3801 -11.1317 +2173 4 29.0166 24.9984 15.2559 10.2779 3.66755 -9.57255 +2174 4 28.1226 23.7858 14.7645 18.214 7.11075 11.8426 +2175 6 20.955 16.2999 1.15679 52.4547 14.172 -5.31351 +2176 4 20.9215 15.3848 1.33551 1.21723 -32.5558 11.4722 +2177 4 20.0795 16.5686 1.08505 -57.8144 13.7968 -3.85053 +2178 6 31.1684 40.7359 5.3086 9.60886 -48.7905 -14.3252 +2179 4 30.3201 40.4364 4.96776 -1.1434 5.1051 1.34806 +2180 4 31.1111 41.6485 5.46945 -11.8258 44.905 11.395 +2181 6 29.926 24.7744 36.4585 -3.76808 18.8348 4.26027 +2182 4 30.4252 25.4661 35.9713 -7.21832 -13.6313 5.02454 +2183 4 29.9738 23.9763 35.9568 8.68635 -20.1437 -13.5665 +2184 6 8.66863 31.0429 3.90108 5.49181 -25.3701 -11.391 +2185 4 7.74616 30.7992 3.95988 -7.56137 -0.630176 -1.16432 +2186 4 8.75287 31.8877 4.30735 2.25384 31.6916 10.4967 +2187 6 5.52708 32.7014 11.4113 -17.1068 -29.6258 4.38787 +2188 4 4.72561 33.1583 11.715 12.8879 6.23598 -5.09299 +2189 4 5.16474 31.7796 11.3163 19.6841 23.1791 1.24929 +2190 6 45.6525 35.4522 20.4433 4.50188 -15.2767 -13.8779 +2191 4 45.1533 35.403 19.6071 0.884587 3.9764 11.125 +2192 4 46.1815 34.6145 20.4501 -8.61117 18.3435 2.22997 +2193 6 19.5135 2.78077 9.78076 -23.679 -24.2198 -16.6656 +2194 4 19.3296 3.70289 9.60293 -7.62346 7.89228 3.64078 +2195 4 18.7563 2.26696 9.35595 24.4568 20.2801 14.4664 +2196 6 54.9521 9.08257 10.915 1.41457 -13.8994 3.08946 +2197 4 54.8451 8.89609 11.8656 1.69601 3.75098 -5.72792 +2198 4 0.659909 9.73404 10.7859 1.63405 2.05096 5.26063 +2199 6 21.028 26.5613 14.7909 22.3934 -16.1712 -61.6784 +2200 4 21.2545 26.1082 13.8887 -5.63248 33.4215 43.8962 +2201 4 20.0757 26.5096 14.8457 -4.66041 -4.09977 8.40724 +2202 6 14.1565 30.5187 27.5481 43.0568 3.88252 13.2649 +2203 4 14.5478 30.2647 28.4319 -11.7888 3.54471 -30.6513 +2204 4 14.9443 30.8429 27.0102 -33.9181 -6.53128 14.6047 +2205 6 29.8147 17.3367 31.0866 -27.8518 -4.92818 12.2149 +2206 4 30.6554 17.4646 30.6741 20.9401 8.7355 -10.9161 +2207 4 29.248 18.1063 30.9142 12.1966 -0.59561 3.44929 +2208 6 50.8794 17.2985 27.8251 -38.7154 2.44379 -6.74856 +2209 4 49.927 17.6315 27.8951 41.9068 -8.6615 -2.42711 +2210 4 51.4551 17.8493 28.3603 -3.47276 2.02156 5.1771 +2211 6 46.2645 37.0852 13.9854 4.42941 -15.3994 -45.1385 +2212 4 46.1048 37.4162 14.8449 -7.65894 23.339 32.9902 +2213 4 45.682 37.569 13.3645 -0.578519 -6.08013 10.2779 +2214 6 38.1859 37.2676 33.1408 3.52211 -11.0724 24.5555 +2215 4 38.5393 37.4103 34.0404 -6.68303 -10.0954 -6.88307 +2216 4 38.6219 37.9461 32.6369 2.42637 17.4604 -15.0111 +2217 6 41.8357 13.3473 31.1178 -16.0625 23.8584 17.742 +2218 4 41.5851 13.9423 31.8754 7.82637 -22.3228 -20.2899 +2219 4 42.4009 12.6411 31.4368 6.59024 -10.1979 3.85371 +2220 6 46.9027 12.6459 17.8387 -27.1897 30.7666 -32.0186 +2221 4 46.619 13.5972 17.8049 11.7948 -22.8605 3.48595 +2222 4 46.5208 12.2901 16.9886 18.0608 -3.03081 22.7278 +2223 6 32.0582 10.0955 10.6527 -31.4378 50.3229 23.4622 +2224 4 31.7762 9.76632 11.5317 8.81554 -8.40176 -19.9459 +2225 4 31.6698 11.0464 10.7004 29.7372 -48.0302 -12.3835 +2226 6 34.0062 11.3773 6.75186 17.7871 30.589 25.6979 +2227 4 33.4869 10.5999 6.69262 -19.6684 -30.9606 -3.70709 +2228 4 33.8274 11.7035 7.66069 0.227829 -0.558148 -16.2574 +2229 6 45.3288 30.8634 19.4834 2.25993 -0.395596 -7.26595 +2230 4 45.2654 30.706 20.4282 2.85912 -9.1252 8.63447 +2231 4 45.808 30.1003 19.1195 -1.86475 4.39364 7.74954 +2232 6 20.3535 0.575918 7.15275 2.53913 19.7072 2.1264 +2233 4 20.3036 0.62077 8.11765 -6.02971 -5.31178 -3.74759 +2234 4 20.3373 41.5708 6.90351 -3.42232 -20.4047 0.354773 +2235 6 15.9901 39.4523 4.14302 -22.6863 14.3541 -4.96379 +2236 4 15.4898 39.956 3.48033 13.9059 -6.08345 -3.0001 +2237 4 15.6535 39.8695 4.95456 5.06581 -11.7067 3.21286 +2238 6 52.4222 16.4823 25.1021 7.38571 -14.026 0.748627 +2239 4 51.9391 16.8928 25.8315 -3.23714 5.96419 -6.435 +2240 4 52.4547 17.0876 24.3371 -9.72126 -3.91711 12.1205 +2241 6 38.5305 12.9945 3.24722 36.6577 77.8042 9.91619 +2242 4 38.7269 13.7231 3.96388 -16.2716 -45.5952 -32.5571 +2243 4 38.0745 12.2732 3.61889 -23.0516 -27.5087 18.4748 +2244 6 35.1404 29.6968 31.1683 -32.7778 -10.63 75.6098 +2245 4 35.326 30.1595 30.3922 19.5999 28.8984 -42.5223 +2246 4 34.769 30.3505 31.8393 8.36493 -22.8372 -28.4638 +2247 6 9.52941 33.7628 4.86075 -28.4918 10.8311 18.4951 +2248 4 9.24769 34.3211 5.62607 6.24621 -9.23174 -22.6788 +2249 4 10.3628 33.3905 5.10095 17.2263 -8.07265 -0.549435 +2250 6 21.5384 22.0668 20.5377 -8.24916 -13.7408 18.0665 +2251 4 20.8389 22.6833 20.2982 1.69112 5.82217 1.92954 +2252 4 21.3229 21.7148 21.445 5.44386 11.4228 -26.5573 +2253 6 37.5752 11.1922 41.2961 -25.7405 -15.8592 15.4541 +2254 4 38.0284 11.8044 40.7564 10.4246 30.4728 -30.151 +2255 4 38.2644 10.586 41.5433 15.0535 -11.8566 15.4014 +2256 6 33.8981 1.42806 38.7459 -9.94409 -6.93964 -8.18458 +2257 4 33.592 0.608166 38.3248 2.39341 2.703 9.2739 +2258 4 33.9534 1.28552 39.7002 -3.4763 3.29487 -4.45631 +2259 6 4.57081 26.6822 28.0049 6.08842 -57.033 -35.5124 +2260 4 5.0914 25.8197 28.0746 -15.9746 40.4578 4.78317 +2261 4 4.85783 27.3427 28.6052 16.6445 16.915 24.1865 +2262 6 10.2586 0.903759 11.6235 -14.777 -30.5961 35.2813 +2263 4 10.598 1.12099 12.5147 -1.53351 -1.03605 -18.7158 +2264 4 10.5217 1.55247 11.0069 12.731 34.1315 -22.4253 +2265 6 17.6428 19.8087 2.34625 28.3489 11.7442 10.4095 +2266 4 17.8694 20.4455 1.65312 -0.920106 -2.92675 2.15413 +2267 4 18.5186 19.4679 2.66241 -18.7748 -2.39069 -7.57655 +2268 6 32.4269 25.6656 16.4745 -22.7384 46.4686 12.005 +2269 4 32.9526 26.0936 17.1754 -0.693509 -13.2017 -11.5041 +2270 4 32.8268 24.9018 16.1119 18.5502 -33.1172 -3.66835 +2271 6 33.2526 10.6326 0.323883 9.44704 -29.8166 -9.67306 +2272 4 32.8511 9.97264 41.5994 12.5609 21.6724 15.7642 +2273 4 34.1113 10.2426 0.662313 -26.6835 12.0422 -7.05376 +2274 6 4.94395 4.51414 10.1428 13.8645 5.4827 29.102 +2275 4 4.09398 4.95549 10.181 -4.94694 -3.34603 -2.54834 +2276 4 5.29018 4.56097 11.0773 -8.61071 -3.77852 -28.7481 +2277 6 27.0981 16.9726 9.55361 -31.982 10.5528 -14.2027 +2278 4 27.1645 17.5497 10.32 4.78099 0.707575 6.97209 +2279 4 26.2221 17.2303 9.15822 25.9284 -7.90001 11.4222 +2280 6 9.97547 10.5192 19.3751 2.18725 8.20489 55.882 +2281 4 10.4385 9.92127 18.8097 14.3325 -20.7925 -15.5795 +2282 4 10.1136 10.195 20.3283 -2.00877 10.2565 -41.5362 +2283 6 19.5726 8.5313 27.8509 32.1681 -5.32712 19.6321 +2284 4 20.0623 8.73326 28.6965 -13.9453 -3.32017 -28.6613 +2285 4 20.1531 7.88958 27.3718 -16.7413 15.1406 10.2365 +2286 6 47.0715 38.9553 23.1297 -19.9487 1.16408 5.20576 +2287 4 47.6755 38.9992 22.3956 6.55525 -5.77104 -8.99339 +2288 4 46.1921 38.7934 22.7438 5.29072 4.97192 1.21114 +2289 6 19.6864 25.3648 11.2698 -35.9279 -4.62509 3.50742 +2290 4 18.9891 24.6498 11.3772 26.0807 25.4649 -7.71219 +2291 4 19.2193 26.1995 11.535 7.74761 -20.7647 -6.77192 +2292 6 27.3916 13.4622 15.7395 34.9583 -25.2468 -27.4167 +2293 4 26.6227 13.8144 16.1317 -23.8298 14.7279 29.1585 +2294 4 28.0863 13.1847 16.3728 -7.05347 8.15442 -0.924368 +2295 6 18.6718 14.1326 1.43279 -0.407031 -28.5308 -28.57 +2296 4 18.3771 15.0354 1.29678 -0.169849 11.7565 -8.38297 +2297 4 19.1904 13.8513 0.615983 -22.2167 19.1803 27.2908 +2298 6 42.3082 22.0346 32.4819 -45.1257 5.10199 -13.868 +2299 4 42.1064 21.5657 33.301 1.02444 -1.81924 7.74271 +2300 4 41.4227 22.4584 32.2639 35.231 -14.359 4.36271 +2301 6 10.0299 9.44853 2.50633 35.8335 -20.1603 -5.5533 +2302 4 9.22808 9.80314 2.87263 -22.9312 8.40439 12.9687 +2303 4 10.3707 8.71125 3.07205 -18.436 14.324 -8.13067 +2304 6 6.82989 1.45163 22.0085 -48.1074 -31.7833 -34.6048 +2305 4 5.93364 1.52189 21.5813 27.761 13.2569 19.2226 +2306 4 6.99793 0.508973 21.801 12.0554 14.7409 9.93393 +2307 6 11.2802 27.0298 18.9733 1.62982 48.8223 -5.8971 +2308 4 11.8533 27.1031 19.7597 -5.53045 -6.49976 -4.21856 +2309 4 11.2066 27.9871 18.6476 2.337 -33.8373 14.078 +2310 6 41.4807 20.5084 27.2133 -10.1157 30.3313 5.28758 +2311 4 41.6238 21.1535 27.9303 0.1153 -0.646751 -15.7402 +2312 4 41.3475 19.7242 27.7174 2.20222 -28.2193 4.24429 +2313 6 15.4457 24.115 33.4309 -8.0908 -15.9975 4.96928 +2314 4 14.6694 24.1264 34.0087 5.2648 16.329 -3.20307 +2315 4 15.6051 23.1634 33.3621 10.6851 2.75783 3.25666 +2316 6 36.1374 16.3773 10.0083 -2.95201 1.72364 21.0093 +2317 4 36.0354 15.4723 9.6971 0.275369 -1.57281 -6.84486 +2318 4 36.1532 16.3058 10.9756 2.3103 1.89663 -9.38056 +2319 6 51.7249 16.2592 2.09899 -0.8354 -35.479 4.00209 +2320 4 51.3025 16.6477 2.84061 -15.4293 29.383 24.1936 +2321 4 51.7588 15.3279 2.40044 5.70816 13.7616 -13.313 +2322 6 23.409 8.55726 39.7719 39.5062 -11.15 -25.6965 +2323 4 23.7264 8.82822 38.8637 -18.295 -2.70527 32.3134 +2324 4 24.154 8.00621 40.1033 -17.8621 14.2471 -2.43096 +2325 6 36.7611 34.4487 21.1056 -9.59584 -7.71653 -9.58874 +2326 4 37.1943 34.5847 20.2534 -2.45984 1.11901 0.357954 +2327 4 35.8017 34.351 20.9183 13.0848 5.20904 4.89404 +2328 6 14.146 8.88688 27.2949 11.3522 43.6232 -16.453 +2329 4 13.5534 8.17113 27.3093 -27.716 -37.4722 8.68734 +2330 4 15.0033 8.5993 27.5988 11.0136 -4.6565 4.44913 +2331 6 20.6652 37.4903 25.1946 -10.211 -17.9881 -36.0994 +2332 4 20.7454 36.6557 24.6643 4.11278 14.2078 23.4923 +2333 4 20.5382 38.1243 24.4693 3.50396 4.35638 18.4557 +2334 6 28.825 24.4792 30.0383 -7.87557 -12.5525 -14.3175 +2335 4 28.2203 24.3409 29.2957 -5.62902 14.2643 8.72595 +2336 4 29.6177 24.0933 29.6588 14.1928 -3.34691 9.72359 +2337 6 8.38024 12.0023 23.6849 17.6034 -17.8042 43.8798 +2338 4 9.33151 12.0391 24.0095 -25.5352 0.9508 -22.7134 +2339 4 7.93543 11.4413 24.3789 8.15752 13.9726 -18.9857 +2340 6 16.0957 26.6613 22.9482 -4.23776 -4.88874 3.00129 +2341 4 16.4041 25.8866 22.4682 2.11349 3.20317 -0.347462 +2342 4 15.2797 26.4088 23.4009 6.04671 4.79823 1.078 +2343 6 22.346 41.3881 9.48723 24.9275 -16.664 -2.62618 +2344 4 22.5706 0.299269 9.06271 5.87112 18.1013 -4.15908 +2345 4 21.5005 41.5154 9.87839 -30.5435 3.49176 4.55444 +2346 6 49.3776 19.1851 32.3736 41.1751 -38.6142 12.6649 +2347 4 49.9515 18.5305 32.8666 -19.8114 22.1793 -24.5398 +2348 4 48.9751 19.6643 33.0815 -18.7203 16.5505 12.5326 +2349 6 29.672 28.434 31.2292 -0.0990093 -59.7528 33.1636 +2350 4 30.5672 28.114 31.0525 8.33151 24.242 -15.2883 +2351 4 29.4026 27.6233 31.7702 -3.76231 36.9508 -17.5145 +2352 6 5.09757 39.1181 23.5694 28.9365 -16.8561 66.257 +2353 4 5.426 38.785 24.4883 -20.96 9.44698 -53.4069 +2354 4 5.17377 40.064 23.6953 -4.19226 13.7611 -6.16678 +2355 6 42.9396 13.594 41.6013 33.1291 -45.1938 12.1175 +2356 4 42.8466 14.3322 41.0449 -16.6361 37.6348 -21.2948 +2357 4 42.1546 13.3797 0.17078 -22.3633 5.8076 7.08965 +2358 6 21.2201 12.4318 7.37385 41.5974 -14.6934 -10.3279 +2359 4 20.2896 12.3563 7.35505 -36.2241 5.92132 -7.85999 +2360 4 21.5284 11.6004 6.96932 1.7608 11.2928 4.8084 +2361 6 43.1404 26.8989 37.6922 38.0431 -66.5876 34.8581 +2362 4 42.455 26.3454 37.3085 -15.3628 11.0452 -11.3741 +2363 4 43.7284 26.1839 38.1775 -25.099 52.0029 -25.4853 +2364 6 19.5406 10.6485 41.687 -7.00401 -34.9019 -10.1363 +2365 4 19.0738 10.6767 0.596923 -7.19888 -1.38148 21.2635 +2366 4 19.8536 11.5162 41.559 12.2515 43.5875 -9.13673 +2367 6 53.6223 10.061 3.2559 12.5469 7.56169 -12.6981 +2368 4 54.2024 10.8465 3.22155 -5.5124 -7.95383 7.8004 +2369 4 54.0687 9.40413 2.68363 -10.8512 12.6529 5.34221 +2370 6 17.5742 20.1926 28.4231 -27.2496 23.4973 23.4861 +2371 4 18.0413 19.6307 27.8376 17.787 -14.8025 -21.0857 +2372 4 18.1273 20.2938 29.2048 3.54631 -0.489564 0.0042962 +2373 6 36.884 7.32584 1.68504 -56.6071 21.2656 -14.3658 +2374 4 37.7051 7.59774 2.01592 38.2946 9.18211 20.2394 +2375 4 36.4748 8.1931 1.44071 3.42518 -20.8507 2.42249 +2376 6 29.2181 41.4159 1.83346 -7.01124 13.363 14.2223 +2377 4 28.4272 0.01466 2.15652 15.3791 -9.50345 -13.4545 +2378 4 29.1899 41.2946 0.880744 -4.61983 7.49126 -6.31737 +2379 6 13.5157 3.09172 8.12958 -12.3356 7.91728 -16.4605 +2380 4 12.824 3.78046 8.01164 12.4629 -9.10221 7.3254 +2381 4 13.8551 3.1491 9.02604 -1.1531 -1.24526 3.73064 +2382 6 15.0243 29.578 18.5071 -0.689822 5.1468 -1.91807 +2383 4 14.6889 28.924 17.8685 -1.8514 4.35612 11.642 +2384 4 14.2858 30.1508 18.7969 8.46412 -5.78667 -10.3485 +2385 6 10.5031 24.7013 24.3729 39.9308 52.3958 -21.489 +2386 4 10.8696 24.6855 23.439 -22.6214 -1.85919 30.3756 +2387 4 10.1444 23.8694 24.566 -23.1097 -44.7323 0.689524 +2388 6 2.33043 13.8499 25.1512 12.2217 -8.49201 10.1592 +2389 4 1.51988 13.5482 24.7402 -5.80441 -9.83551 -11.7005 +2390 4 2.2572 14.7938 25.1495 -10.3249 16.8303 -2.61333 +2391 6 31.8608 32.7615 29.8175 -5.917 1.92483 -13.0568 +2392 4 30.9148 32.9142 29.9093 1.86919 3.45723 4.06263 +2393 4 31.9038 31.8703 29.4643 1.33296 -6.10517 -4.90202 +2394 6 37.5413 40.8309 33.9785 -53.8639 -49.1526 -10.38 +2395 4 37.2515 40.0243 34.5353 23.0474 40.5808 -8.35317 +2396 4 36.818 40.8104 33.2846 24.4839 11.2763 19.2644 +2397 6 24.0486 38.1463 34.3459 4.38709 -25.8386 -29.9356 +2398 4 24.1932 38.0251 35.2675 1.20986 12.6476 31.9448 +2399 4 24.4562 37.3431 33.9843 -4.45208 9.66559 -5.62065 +2400 6 37.1813 22.5726 7.37313 12.7367 -26.0408 21.8779 +2401 4 37.6868 21.7363 7.50199 -14.9443 17.386 1.08188 +2402 4 37.2974 22.7741 6.46124 2.1827 3.60906 -24.8808 +2403 6 4.31908 23.2435 35.594 -25.7168 -2.52913 6.61784 +2404 4 4.31865 22.3787 35.1609 -1.33991 4.89576 -0.266123 +2405 4 3.37757 23.4898 35.7698 13.7393 -2.9658 -3.46645 +2406 6 15.7444 14.893 2.66063 14.3192 36.2435 46.5189 +2407 4 15.9445 15.8567 2.71494 4.00237 -25.0016 7.78932 +2408 4 15.3014 14.8369 1.84861 -12.1852 -13.1154 -36.1328 +2409 6 48.1607 23.1823 2.03014 17.998 -4.54201 -11.9107 +2410 4 48.5744 23.458 2.84259 8.43731 2.94545 12.5813 +2411 4 48.9225 22.9045 1.46682 -22.9697 5.41467 1.46601 +2412 6 24.1212 19.9771 21.5555 -13.5297 -6.85262 15.9953 +2413 4 24.2241 19.3198 22.2577 -12.7792 13.8262 1.69378 +2414 4 24.7627 19.6352 20.9706 23.452 2.79195 -33.2435 +2415 6 10.5793 29.3754 5.15175 -1.75103 26.9922 -14.4666 +2416 4 9.93004 29.8841 4.64694 -13.9608 -12.0643 5.47156 +2417 4 11.3599 29.8389 4.86113 16.4531 -5.21099 6.28998 +2418 6 5.96767 27.6933 31.2336 10.2296 -18.0279 -26.5205 +2419 4 6.63185 27.1353 30.7398 -17.0624 11.0978 13.8341 +2420 4 6.49058 28.2721 31.7915 6.44996 0.578865 12.7715 +2421 6 18.5397 25.8071 15.3312 30.8629 -17.2743 -78.9847 +2422 4 18.3277 25.7099 16.2038 -28.7942 6.39581 79.7195 +2423 4 17.897 26.3418 14.8644 -17.4943 11.9017 11.8989 +2424 6 52.0949 37.2335 11.1138 -0.736115 -25.1617 0.200807 +2425 4 52.5552 36.4743 10.7101 2.49656 11.0988 9.7325 +2426 4 52.7586 37.8745 11.3958 -2.29245 7.10647 -7.85035 +2427 6 46.8562 14.6296 7.3094 -39.0502 -6.9365 63.794 +2428 4 46.1382 15.0906 7.8718 34.2719 -4.68193 -40.7336 +2429 4 47.0431 13.9061 7.9424 14.2062 7.46383 -20.3992 +2430 6 22.2508 0.698906 41.6783 16.129 -5.34947 -25.8041 +2431 4 22.2008 1.66415 41.7125 4.72421 -6.65403 -6.59212 +2432 4 22.9559 0.389699 41.0229 -20.0941 20.4891 31.5318 +2433 6 4.05761 14.7345 9.27152 -10.7438 13.6286 -6.0443 +2434 4 3.56043 15.5915 9.15395 12.8436 -23.8424 -1.56379 +2435 4 4.93811 14.8828 8.92118 3.87558 5.66633 -1.10852 +2436 6 37.2917 12.6666 37.0157 -30.741 -16.0859 47.3668 +2437 4 37.7371 12.676 37.8973 0.89189 9.6387 -16.8975 +2438 4 36.3707 12.3712 37.2872 32.4569 8.65188 -22.8431 +2439 6 26.6682 29.0903 40.5985 -18.9168 16.4285 3.4146 +2440 4 27.032 28.2632 40.812 19.8197 -36.7417 16.2821 +2441 4 26.6469 29.0593 39.6552 2.37875 14.8387 -20.8034 +2442 6 7.22455 13.851 3.31845 32.6668 -55.3021 -17.7697 +2443 4 8.0198 14.2759 3.60088 8.05656 35.1068 9.02454 +2444 4 7.66854 12.9807 3.04146 -45.3946 28.1811 11.8363 +2445 6 8.95271 34.8627 28.8342 33.802 -52.1542 -15.9648 +2446 4 9.89817 35.0055 28.6074 -18.5208 0.484683 7.95646 +2447 4 8.56267 35.6958 28.9173 -17.8026 46.8286 13.0667 +2448 6 37.1756 40.0691 40.1061 46.0034 7.56439 6.60252 +2449 4 36.245 40.1688 40.0074 -20.2243 -4.13511 -1.70673 +2450 4 37.2907 39.5142 40.8911 -6.64471 -1.97244 -3.69085 +2451 6 30.3689 6.165 27.2364 16.9392 12.8422 63.3115 +2452 4 30.1126 5.75506 28.1249 0.00544273 9.78172 -37.0876 +2453 4 31.0397 6.83064 27.5702 -18.6179 -11.6186 -23.6342 +2454 6 10.4791 22.885 18.2972 2.22892 -25.7937 -34.5052 +2455 4 11.3494 23.0331 18.653 10.7715 4.73748 7.10061 +2456 4 10.6446 22.3032 17.5049 -10.188 21.0769 23.5682 +2457 6 35.8886 14.2524 40.1239 38.6938 29.9036 -1.43051 +2458 4 35.4161 14.6576 39.3846 -1.71718 -13.5804 13.4977 +2459 4 35.4021 13.6019 40.5864 -31.0402 -18.1501 6.5583 +2460 6 6.71723 1.08854 17.7001 -3.83901 -60.8198 25.71 +2461 4 6.23156 1.19942 18.5167 -3.21909 18.7445 0.671973 +2462 4 6.88149 0.099135 17.7878 0.895752 34.2898 -15.7018 +2463 6 41.3468 34.0461 33.1794 10.5682 19.0983 -18.7578 +2464 4 40.4721 34.2712 32.8864 -29.2649 -1.70533 3.43004 +2465 4 41.8357 34.5632 32.5195 11.425 -3.18121 9.05585 +2466 6 37.2595 0.990816 41.287 9.45411 17.3584 -9.40071 +2467 4 37.687 0.20533 40.9743 -1.4253 -22.058 -8.3634 +2468 4 37.4586 1.01742 0.30817 4.28067 1.92511 18.4856 +2469 6 25.2602 30.9527 6.20609 -41.9214 10.7977 -12.9978 +2470 4 25.877 31.4326 5.6764 28.9604 0.775163 -4.96937 +2471 4 24.4759 30.9469 5.60333 12.4846 -9.23957 25.2824 +2472 6 14.2056 24.502 28.3086 -25.5247 14.5131 -24.5719 +2473 4 14.1882 23.6623 28.7056 13.4522 -31.4953 30.087 +2474 4 13.7133 24.2842 27.5041 7.94148 19.2098 -3.82225 +2475 6 34.2051 26.2238 36.0112 -48.9031 41.3361 24.9979 +2476 4 35.1144 26.3624 36.1822 32.7561 -2.50775 4.45543 +2477 4 33.7446 26.9807 36.5344 19.2218 -36.9328 -23.3608 +2478 6 32.3568 8.33098 28 25.7802 40.2385 3.20277 +2479 4 32.7565 9.24505 28.063 -37.9579 -17.4528 3.85033 +2480 4 33.1461 7.94224 27.6538 8.5967 -27.8742 -9.28785 +2481 6 11.7867 0.286536 26.9724 -1.3913 -35.2382 4.72224 +2482 4 11.7865 41.2385 26.6946 0.846362 23.7064 4.93964 +2483 4 11.6054 0.272418 27.9282 2.03777 4.09428 -12.4872 +2484 6 1.68124 0.254113 10.3309 8.7986 -13.2184 -15.0921 +2485 4 1.59717 41.2916 10.7333 -0.0350141 -2.89412 -0.990995 +2486 4 1.41389 0.849687 11.0071 -7.7361 15.4014 20.6266 +2487 6 6.75173 13.8377 8.23874 -3.6693 30.6435 -30.4665 +2488 4 6.43924 13.9799 7.29904 9.51956 -14.6006 30.1073 +2489 4 7.1653 14.6974 8.43116 5.95594 -9.45057 4.81521 +2490 6 22.2348 20.5564 6.16471 -24.0844 -9.72934 13.195 +2491 4 21.6727 21.3518 6.25881 9.87637 -7.56006 0.262552 +2492 4 21.7029 19.8181 6.55593 11.5262 14.9976 -6.6436 +2493 6 17.385 20.4497 10.8769 -35.9329 27.9153 -37.8305 +2494 4 16.5515 20.156 10.4074 25.3596 -4.97581 21.0147 +2495 4 17.441 21.3848 10.5386 11.6957 -25.2138 21.3318 +2496 6 17.7006 4.52737 19.573 -11.3777 -34.9061 -6.08889 +2497 4 17.032 4.43128 20.2569 -5.49224 11.1956 3.68583 +2498 4 17.4813 3.72403 19.0236 15.4315 33.5846 4.92098 +2499 6 0.483339 18.1114 40.0861 11.4726 -7.5634 -25.4826 +2500 4 0.218803 18.6551 40.8031 -6.40406 19.3 17.6992 +2501 4 1.29471 18.4968 39.6981 -7.50073 -9.94226 4.45973 +2502 6 22.9439 24.8131 27.8304 -1.07592 37.7895 -56.3844 +2503 4 22.8309 25.5845 27.1671 -0.125595 -37.7338 24.1587 +2504 4 22.7938 25.2149 28.6606 -3.1997 14.6603 34.334 +2505 6 42.7926 39.1547 26.7662 4.75434 20.2168 6.00074 +2506 4 43.0175 38.5002 26.1242 -2.01943 -24.6309 -11.9253 +2507 4 43.3024 39.9142 26.4608 -1.73796 0.515913 11.2644 +2508 6 26.2338 3.05974 21.8008 -0.713756 21.3652 -6.58596 +2509 4 25.6341 3.75271 22.1513 17.432 -13.3686 -8.49125 +2510 4 26.841 3.50549 21.1637 -15.4189 -7.95734 10.2455 +2511 6 54.5913 9.88629 29.5891 14.6194 -0.200122 15.6168 +2512 4 54.0185 9.11016 29.6389 -2.18077 1.53735 0.0476299 +2513 4 54.8498 10.0557 30.5251 -12.748 -2.88746 -21.9109 +2514 6 24.7662 33.7505 20.5324 -4.4887 -11.5901 7.32024 +2515 4 24.6764 34.6709 20.8407 -1.82029 -5.26135 -2.53883 +2516 4 23.9322 33.4503 20.1388 -0.463927 12.2923 -3.35723 +2517 6 41.7034 16.3049 0.90063 -4.83399 22.4927 -47.1255 +2518 4 41.2734 15.9533 1.64089 -16.394 -13.425 40.883 +2519 4 42.6233 16.3659 1.12415 18.2298 -9.67465 4.77205 +2520 6 23.3998 27.9207 27.4832 -10.7606 37.0497 -28.3533 +2521 4 22.8282 28.3407 28.1441 5.00816 -9.79407 0.156118 +2522 4 23.2556 28.495 26.6632 8.58882 -24.5485 28.392 +2523 6 32.7859 37.2984 18.7364 25.7014 -40.2058 6.96479 +2524 4 33.7401 36.9719 18.7703 -32.5146 22.7172 4.70252 +2525 4 32.7784 38.1932 18.4283 6.4981 19.1078 -10.0488 +2526 6 21.2249 27.6889 4.78917 1.7584 -25.2435 -20.8654 +2527 4 20.596 27.4146 5.46499 -5.42949 1.48454 -4.75098 +2528 4 21.0369 27.1287 3.96943 -0.427807 22.4392 26.4825 +2529 6 54.9457 17.9605 1.83049 24.1732 12.1415 15.992 +2530 4 54.6765 17.1472 1.44643 -11.2843 -21.2768 -12.0273 +2531 4 54.1938 18.5428 1.86671 -18.1074 1.0363 -7.50679 +2532 6 36.7435 10.702 6.59289 -49.1612 2.30359 2.88264 +2533 4 35.7736 10.9925 6.66913 36.3355 -9.83622 -8.29906 +2534 4 36.7226 9.77144 6.87602 6.19961 4.27664 0.325158 +2535 6 54.2959 4.49421 14.021 -47.0247 26.1641 -8.2037 +2536 4 53.712 4.99768 13.3924 28.2438 -8.88077 8.93165 +2537 4 53.834 4.66365 14.8572 10.6634 -9.95324 4.36694 +2538 6 22.1071 12.8195 32.0067 31.7906 8.9597 -11.0311 +2539 4 21.2967 13.3066 31.9589 -27.922 0.108445 -0.906739 +2540 4 22.6887 13.2954 31.3728 -6.4895 -15.5456 16.1837 +2541 6 15.3021 36.6565 4.03444 -21.8215 23.8176 13.2077 +2542 4 15.3262 37.6185 3.88215 -1.10116 -7.72226 9.53853 +2543 4 16.0423 36.3695 3.52653 17.7184 -15.2462 -10.6327 +2544 6 23.951 1.27123 5.71091 12.3119 19.4094 13.4558 +2545 4 23.1735 0.716989 5.76524 -11.3354 -5.61231 -0.786433 +2546 4 24.0519 1.77027 6.55293 -6.00641 -12.6326 -15.7345 +2547 6 14.2792 12.648 15.8066 19.0644 9.13243 11.8341 +2548 4 14.5911 12.5731 14.893 -12.6174 -10.6299 -3.28453 +2549 4 13.3818 12.3002 15.9605 12.2346 2.97194 -15.7557 +2550 6 15.0388 40.2481 6.5891 -30.9219 -16.0267 -20.9978 +2551 4 15.8926 40.3583 6.97574 17.8619 16.6743 19.574 +2552 4 14.4622 41.0349 6.73493 18.0926 -11.8876 3.06612 +2553 6 48.5605 32.6308 12.0872 21.4935 -15.1737 -19.6402 +2554 4 48.2882 31.8163 11.6222 -11.7375 10.5522 8.8403 +2555 4 49.3772 32.8772 11.5869 -20.063 0.749688 13.0696 +2556 6 11.2909 31.5377 7.21713 -14.6129 -9.26005 -15.8818 +2557 4 10.6224 30.9548 6.78826 17.7824 9.96971 10.6082 +2558 4 11.6163 32.1134 6.50388 0.884245 -9.77636 6.63484 +2559 6 30.1231 27.9968 10.2226 9.10006 8.28679 -14.6513 +2560 4 30.718 28.7273 9.95045 -8.34799 -9.59518 10.9295 +2561 4 29.9727 27.4897 9.40845 -5.6962 -0.318113 1.27302 +2562 6 27.6759 22.1164 17.3809 2.93811 -8.1883 -22.8269 +2563 4 27.2909 21.5233 16.7142 1.55949 -2.9899 10.1125 +2564 4 28.0309 22.8242 16.8263 2.77593 4.45495 11.6125 +2565 6 12.9654 4.59514 18.1625 -0.934721 -11.3223 -0.518608 +2566 4 13.4589 3.798 18.4727 -12.2499 12.1104 -13.3514 +2567 4 12.4628 4.36939 17.3497 12.7979 1.84773 4.27522 +2568 6 19.7203 6.71654 19.0744 25.855 21.5282 16.2244 +2569 4 18.977 6.16103 19.2554 -18.9537 -21.446 -0.739234 +2570 4 20.1996 6.78409 19.9214 -9.72031 -0.922856 -11.6068 +2571 6 37.1527 31.3787 11.4669 20.5156 -3.08539 55.9419 +2572 4 36.5467 31.6235 12.1801 -19.4555 -0.126446 -17.2692 +2573 4 37.8531 31.0173 12.0578 -6.7166 -8.42047 -30.0342 +2574 6 3.11862 16.2015 27.3491 -14.8948 -19.7352 -9.46107 +2575 4 2.52427 15.4561 27.6487 20.3886 21.5408 -12.2486 +2576 4 3.15348 16.212 26.3649 -6.24389 -0.0501167 23.7097 +2577 6 15.7133 9.97724 38.3591 30.328 17.4212 13.8857 +2578 4 16.1258 10.8398 38.0549 -11.3336 -30.4403 16.2583 +2579 4 16.257 9.66317 39.1359 -16.0932 10.0631 -23.9552 +2580 6 13.4043 14.2884 8.2363 15.0986 25.1191 -5.83206 +2581 4 13.804 15.2225 8.33958 -5.13839 -47.7054 6.28407 +2582 4 14.0947 13.5837 8.31616 -11.6402 16.8216 1.41307 +2583 6 1.71524 24.3141 36.392 36.4901 -22.2748 31.9402 +2584 4 1.86474 25.1068 36.8985 9.35176 9.25273 5.49175 +2585 4 1.1215 24.6177 35.7571 -36.8309 10.6894 -41.0698 +2586 6 11.1862 26.5319 32.9688 15.239 -24.9993 36.2438 +2587 4 10.9649 26.8002 32.096 -11.5382 16.0703 -24.8314 +2588 4 11.1647 27.266 33.6054 -7.17864 1.89937 -11.754 +2589 6 29.5773 0.765668 36.2911 32.6527 8.9619 33.1448 +2590 4 29.1495 0.596705 35.4758 -23.483 -6.97315 -25.4485 +2591 4 28.9625 1.07408 36.9696 -5.35236 0.153158 -12.2969 +2592 6 43.6099 13.1071 23.908 -7.75428 16.7256 -33.2383 +2593 4 42.8302 13.3868 24.3919 -4.08537 -1.1131 9.93358 +2594 4 43.3622 13.2586 22.9511 7.4693 -9.27191 32.0602 +2595 6 7.44309 19.7767 19.6705 17.8438 12.6527 -6.23579 +2596 4 6.73015 19.1919 19.919 -3.61392 -10.9972 -0.189724 +2597 4 7.6227 19.7194 18.722 -11.1837 -0.704544 3.42764 +2598 6 24.4259 4.29913 7.83629 -8.5248 -0.10499 -3.36953 +2599 4 24.144 5.21077 7.98541 -0.150025 -7.47068 -3.31634 +2600 4 24.9904 4.0546 8.57206 4.90899 -0.271036 -1.18338 +2601 6 51.4883 30.2308 31.1674 -14.7545 1.56633 -0.747328 +2602 4 50.5925 29.8847 31.2768 -1.35209 3.55691 8.49804 +2603 4 51.5844 30.2463 30.2146 11.2248 2.3182 -11.9335 +2604 6 0.913373 23.6795 16.8764 44.9279 -35.4578 23.1065 +2605 4 0.053834 23.3329 16.7065 -24.7033 4.18361 -15.1926 +2606 4 1.39802 22.8443 17.1197 -4.68332 28.5423 -3.90241 +2607 6 45.0884 19.3939 15.6913 9.05154 29.148 -44.7311 +2608 4 45.9115 18.9543 15.4906 10.1171 -6.0821 0.331933 +2609 4 44.8041 18.9926 16.4702 -27.3917 -26.115 43.7395 +2610 6 17.5003 8.70625 40.5861 -20.5343 49.5779 -9.15489 +2611 4 18.1762 9.35755 40.8219 0.532033 0.318295 -4.52849 +2612 4 17.8864 7.89597 40.8225 20.4785 -39.0634 11.6529 +2613 6 30.1832 27.259 27.1983 -17.9859 30.5387 -1.70378 +2614 4 31.0843 27.5469 27.0174 5.19664 -5.65516 3.8328 +2615 4 29.6652 28.1124 27.2385 17.8651 -30.9588 0.0373123 +2616 6 43.0672 26.1987 28.3737 -1.21405 11.7795 -35.2128 +2617 4 43.2187 25.7399 27.5308 2.18298 5.51683 1.33219 +2618 4 43.1307 25.5038 29.0079 -1.74848 -11.3154 21.2466 +2619 6 27.987 7.5851 3.0601 9.13665 18.2748 23.7588 +2620 4 28.1896 6.93215 2.40721 -2.30749 -24.2619 -13.6918 +2621 4 28.5512 7.39371 3.84357 -9.52219 0.418204 -9.11945 +2622 6 44.6779 7.22362 10.1855 -3.82519 12.3682 29.7072 +2623 4 44.5846 7.37997 11.1613 -8.64186 4.71212 -23.3906 +2624 4 45.2067 6.43644 10.1815 9.68596 -14.557 -3.94398 +2625 6 23.537 20.3907 32.2607 -4.33975 0.880185 -5.57314 +2626 4 23.324 21.1985 32.7413 -3.519 5.94106 -1.71472 +2627 4 23.9311 19.8373 32.9365 5.99895 -7.24541 1.02787 +2628 6 37.5412 21.0533 29.2807 6.26587 16.0676 16.0196 +2629 4 37.3761 20.3248 28.6837 -16.0493 -11.7352 -10.5522 +2630 4 36.7218 21.4261 29.6708 7.43039 -8.09007 -9.52559 +2631 6 49.2859 29.0787 28.7031 8.16517 -18.5587 -1.11584 +2632 4 48.658 29.8007 28.598 1.09858 8.52384 -10.5349 +2633 4 50.1522 29.3365 28.3345 -7.12297 8.09394 6.40204 +2634 6 47.5144 18.1684 15.2382 -13.098 45.3115 -50.4885 +2635 4 48.063 17.6794 15.7982 26.613 -22.2712 34.0874 +2636 4 48.011 18.9832 14.9644 -13.0138 -21.3801 10.9042 +2637 6 23.2587 11.168 16.5961 -34.2623 -16.0228 11.9175 +2638 4 23.8181 11.8474 16.2701 22.3391 18.1069 -12.9732 +2639 4 23.6107 10.3074 16.3447 5.63526 2.71733 -4.05723 +2640 6 3.14661 8.32736 23.1966 -5.33081 14.6732 5.33529 +2641 4 3.33443 7.84562 22.3891 5.23826 -4.81966 -4.36628 +2642 4 3.62138 9.17513 23.1245 -2.82501 -4.35917 1.75332 +2643 6 0.508878 16.1819 6.17622 16.4304 7.97407 55.7173 +2644 4 1.47866 16.3831 6.12713 -25.5039 -9.61354 -6.44341 +2645 4 0.329178 16.1408 7.1857 2.48639 -0.0834422 -46.7437 +2646 6 43.1796 15.6993 5.84098 -15.9449 -20.1226 -10.4934 +2647 4 42.9586 16.4507 6.36104 0.864404 19.5468 17.3894 +2648 4 44.0486 15.8407 5.47017 17.9332 8.6581 -2.45416 +2649 6 16.7038 35.4743 34.4518 -23.198 12.4372 32.502 +2650 4 15.9504 35.0582 34.0028 7.47206 -3.63127 2.95791 +2651 4 16.3197 35.7905 35.3305 20.1374 -9.24319 -26.2799 +2652 6 38.8854 7.73874 15.6833 27.6202 35.8952 13.402 +2653 4 39.2486 7.07212 15.1014 0.737034 -8.76325 -8.48971 +2654 4 39.6641 8.33099 15.9666 -32.1226 -27.7665 -11.1551 +2655 6 42.0076 36.5182 13.641 -8.45099 16.164 -4.64077 +2656 4 41.9228 35.5752 13.5656 2.538 -16.9665 4.44933 +2657 4 41.1544 36.8356 13.3036 3.7559 4.14555 2.82714 +2658 6 54.2986 15.3848 32.1119 10.5246 -16.1102 10.831 +2659 4 0.035655 15.9755 32.3754 -8.42237 -3.15332 1.00609 +2660 4 53.5781 15.9253 31.7943 -3.3302 7.96061 -4.64421 +2661 6 22.8954 13.9973 39.0304 35.7671 -1.21675 7.49641 +2662 4 23.2761 14.8055 39.421 -4.93619 -7.73369 -6.00904 +2663 4 21.9819 14.1606 38.8837 -32.0989 6.28079 -4.51925 +2664 6 48.0426 28.53 4.78367 -18.7604 -12.0579 33.007 +2665 4 48.5209 28.7824 4.01456 21.1512 11.8238 -22.7946 +2666 4 47.6247 29.3288 5.14776 5.26678 3.3179 -1.38234 +2667 6 48.833 10.6059 2.66638 -9.19187 -9.9608 -41.9733 +2668 4 48.2371 10.184 3.25557 -19.2293 -15.3999 15.8868 +2669 4 49.4018 11.1117 3.19515 27.1663 25.8201 26.2609 +2670 6 17.1043 29.3494 4.41938 0.116954 -3.05469 4.91749 +2671 4 16.3442 28.823 4.73493 -1.75912 12.177 1.49975 +2672 4 17.4207 29.929 5.14153 -0.429925 -17.6765 -0.899977 +2673 6 27.7901 7.33424 26.577 58.6208 -10.7281 -9.65958 +2674 4 28.6921 6.89516 26.6033 -20.1634 35.8081 4.28732 +2675 4 27.2961 6.54785 26.6418 -36.3357 -24.7905 3.70209 +2676 6 18.0242 22.0537 22.5144 -27.9591 -16.1551 -40.0832 +2677 4 18.4878 21.2118 22.5153 10.7066 -2.42354 6.7168 +2678 4 17.4966 21.98 21.6478 21.0889 16.8172 36.9195 +2679 6 22.144 25.0979 16.6837 -22.767 31.6961 -6.75713 +2680 4 21.8754 25.6012 15.8609 3.46788 -12.1894 37.0641 +2681 4 22.4796 24.2953 16.3382 13.1119 -24.3628 -7.92486 +2682 6 25.5147 28.4379 7.13209 -32.2353 18.5879 42.0502 +2683 4 25.3191 28.6153 8.09624 16.8162 -18.2828 -29.7283 +2684 4 25.4949 29.3399 6.82105 5.5127 9.28731 -21.7507 +2685 6 42.5447 24.7469 23.7482 -26.0567 17.8354 -0.260974 +2686 4 41.659 25.0561 24.0862 27.8337 1.55541 -7.56443 +2687 4 42.5141 23.8045 23.8516 -5.7883 -22.6777 0.706816 +2688 6 6.24511 16.6188 2.47068 -21.6781 9.7655 5.77715 +2689 4 5.36273 16.9874 2.41541 -6.24724 13.8235 -1.18511 +2690 4 6.01398 15.7093 2.58331 16.9883 -26.009 1.35247 +2691 6 47.3719 33.28 1.46148 -3.99946 1.01934 -28.2481 +2692 4 46.9803 34.1218 1.66358 -4.59906 12.9067 -8.65937 +2693 4 47.69 33.0389 2.30921 14.6803 -12.3184 23.7614 +2694 6 1.27616 36.1851 24.8829 8.16993 1.58395 -5.27854 +2695 4 0.639753 36.4584 25.5359 -13.8461 11.829 3.50901 +2696 4 1.57271 35.3754 25.2942 10.46 -9.74103 -2.86729 +2697 6 20.9413 29.0442 16.4303 -37.0385 3.95749 11.2157 +2698 4 21.4069 28.5201 15.8013 19.747 -14.8546 -14.4583 +2699 4 21.4101 29.8248 16.6953 16.4704 9.62387 -0.234111 +2700 6 18.6701 32.5426 14.1399 -11.935 -28.2137 10.094 +2701 4 17.8036 32.9051 14.2078 -15.3524 29.2867 2.90472 +2702 4 18.4356 31.618 14.3552 23.1856 4.50503 -1.59621 +2703 6 15.7338 41.7002 0.007017 -29.1796 -38.8659 -6.04008 +2704 4 15.5134 41.1073 41.1476 16.5192 17.684 16.0218 +2705 4 15.1804 41.3134 0.738607 16.9589 18.7767 -12.0866 +2706 6 20.5358 18.4015 7.20723 -36.4209 10.7746 11.3165 +2707 4 20.1727 18.4996 8.12034 18.5895 1.11111 -8.73102 +2708 4 19.7156 18.4439 6.66948 20.5956 -6.66311 2.45516 +2709 6 35.3359 2.82506 1.61733 -4.03181 47.7257 29.2165 +2710 4 34.9541 3.20961 2.47337 19.1106 -23.159 -34.5889 +2711 4 35.8528 3.61912 1.28524 -9.69035 -30.1723 1.40188 +2712 6 49.0059 19.6751 24.9502 -26.306 10.305 -4.58994 +2713 4 49.8292 19.282 24.7191 18.9727 -16.8119 -2.00329 +2714 4 49.219 20.61 24.9195 -6.54834 1.96917 8.98321 +2715 6 26.0427 7.1974 41.5664 19.1127 -25.9459 -27.3591 +2716 4 26.6886 6.46136 41.6822 -6.92827 19.3426 1.38611 +2717 4 25.5576 7.23966 0.456505 -11.7101 6.8047 33.8929 +2718 6 22.0248 3.60461 29.0185 -16.0846 7.25678 -9.40108 +2719 4 21.194 3.80897 28.5456 14.569 -4.87522 0.502932 +2720 4 22.1959 4.40114 29.525 4.81678 0.210141 7.58007 +2721 6 27.8548 32.5394 20.644 30.2008 -27.0251 30.2495 +2722 4 26.9598 32.7332 20.4747 -36.3343 12.7784 -11.814 +2723 4 28.412 33.1097 20.1287 0.615935 11.6015 -11.5439 +2724 6 8.3956 24.7909 3.45677 41.8783 30.6212 2.1827 +2725 4 8.85983 24.2427 2.83372 10.4085 -11.4169 -11.9204 +2726 4 7.65564 24.3184 3.74512 -41.6031 -24.257 6.19876 +2727 6 30.5856 41.7288 15.6573 18.8319 11.6475 40.5199 +2728 4 29.9513 0.161741 16.3149 8.82373 -8.1621 -4.69308 +2729 4 30.0935 41.6309 14.8822 -24.2072 -8.84927 -42.274 +2730 6 48.0984 5.63232 21.2085 -24.8678 -8.67647 -10.7387 +2731 4 47.6235 6.28714 20.6867 8.63769 7.09972 -0.446275 +2732 4 47.3595 5.05066 21.4474 12.3779 0.983941 9.20385 +2733 6 39.4236 23.163 35.7324 -26.6807 -22.8308 -31.4054 +2734 4 39.8477 23.6904 36.3502 31.9199 30.6139 46.0523 +2735 4 38.8623 22.5516 36.2186 -1.29306 -3.58423 7.04543 +2736 6 51.5883 33.3617 5.78995 -19.5798 -55.0773 -18.3228 +2737 4 51.7861 34.2574 5.89467 9.96767 53.6603 7.25336 +2738 4 51.5145 33.1869 4.82901 1.99858 6.27826 11.2132 +2739 6 40.1205 17.6413 30.7797 3.51386 -32.8888 9.0941 +2740 4 39.6335 18.3955 31.0853 6.47279 10.0891 -2.42254 +2741 4 40.8254 17.9321 30.1952 -5.08805 1.72673 -6.80625 +2742 6 46.4235 9.81086 18.5807 -13.6096 13.2326 25.0066 +2743 4 47.164 10.4099 18.4597 3.17276 -2.49269 -0.272695 +2744 4 46.3941 9.2422 17.832 2.02048 -17.819 -25.0993 +2745 6 15.8844 41.0843 31.9336 24.9021 -3.26155 -16.7898 +2746 4 16.5805 40.7078 31.3592 -9.31569 -10.1627 6.74042 +2747 4 16.1791 0.090931 31.8861 -11.051 9.97246 9.22539 +2748 6 48.5496 25.7276 14.9325 -23.4699 4.48431 -20.1118 +2749 4 49.4421 25.9075 14.7294 36.7388 1.67727 3.80263 +2750 4 48.1707 25.827 14.039 -11.0362 0.596064 15.3478 +2751 6 39.2225 28.9892 36.1575 1.81804 -9.3363 -11.5399 +2752 4 40.0459 29.1043 36.6225 6.32097 13.8964 11.0865 +2753 4 39.5169 28.7877 35.2623 -5.25992 -5.15898 -10.721 +2754 6 37.325 21.0738 14.9394 -7.85324 -20.9229 -64.7065 +2755 4 37.9996 20.7799 14.2865 -1.58038 10.9233 26.036 +2756 4 36.5898 21.2349 14.28 11.1979 5.88457 46.2171 +2757 6 32.4971 22.8607 15.7433 -7.91212 -33.4559 24.7905 +2758 4 31.7632 22.4534 15.25 1.55934 10.0805 -2.32687 +2759 4 32.5592 22.2921 16.5663 4.31702 21.463 -27.4441 +2760 6 18.5773 8.13014 37.5708 2.8796 34.5567 21.0854 +2761 4 19.1021 8.93687 37.8089 1.20854 -19.8484 -10.1251 +2762 4 17.9431 8.09722 38.288 -3.97249 -3.14491 3.87795 +2763 6 46.9308 30.3817 11.0144 7.20248 -9.32119 -46.6603 +2764 4 46.4987 30.7035 10.1833 6.25688 -3.94108 30.979 +2765 4 47.431 29.6318 10.6212 -6.26387 6.19468 23.2459 +2766 6 54.6355 13.051 30.6677 -0.631529 -12.3617 0.377161 +2767 4 54.9401 12.1973 31.0202 -4.70537 6.73717 3.83911 +2768 4 54.6706 13.679 31.4001 -0.542159 7.57402 -2.77471 +2769 6 32.2973 35.1412 27.9506 0.702746 7.41177 51.9011 +2770 4 32.3519 35.6753 28.7977 -4.11304 1.55554 -34.3644 +2771 4 32.0809 34.2722 28.2835 1.42742 -15.3938 2.35714 +2772 6 4.45353 25.396 31.7914 -28.2716 -32.1048 1.32297 +2773 4 5.00928 24.905 32.4172 3.79617 9.45861 3.32159 +2774 4 4.83781 26.2295 31.6234 26.2458 34.1175 0.407684 +2775 6 40.7781 38.1509 21.8521 -13.1408 -33.509 11.5706 +2776 4 40.6716 39.044 22.1698 7.33695 21.0707 -1.24628 +2777 4 41.4481 38.0623 21.1738 10.5508 14.8215 -9.14642 +2778 6 26.6931 9.85845 27.4042 -43.8759 24.145 24.882 +2779 4 26.9952 9.1619 26.8761 23.7363 -35.7414 -23.7206 +2780 4 25.7673 9.60487 27.6152 14.5566 8.07269 5.62533 +2781 6 53.3967 39.4485 11.7649 68.843 -10.0355 -14.0333 +2782 4 54.4148 39.3855 11.5456 -53.2103 8.20916 12.7106 +2783 4 53.105 40.2482 11.2866 -1.29569 -7.05369 14.3337 +2784 6 35.3292 21.4155 2.23587 15.106 -7.83484 -18.4876 +2785 4 34.912 20.5764 2.48744 -1.27765 6.93695 -0.309601 +2786 4 35.8084 21.2289 1.37944 -21.1629 3.53466 26.6292 +2787 6 4.14409 17.1449 33.9131 -16.1644 -22.9901 22.0601 +2788 4 4.14131 16.4411 34.6063 8.69636 10.7601 -14.4963 +2789 4 3.20404 17.192 33.6728 6.06844 1.20479 -9.99864 +2790 6 24.1486 16.1886 14.6752 2.90394 -28.6462 -21.9437 +2791 4 24.2343 17.059 15.0346 0.494679 15.8947 1.83084 +2792 4 23.7735 16.3203 13.7888 -2.47926 -0.947779 4.85435 +2793 6 43.1303 2.83022 26.0988 7.42094 18.4339 -15.1049 +2794 4 42.3152 3.21229 26.4285 -6.54764 -1.84254 4.96768 +2795 4 43.2129 3.23454 25.2082 4.91034 -11.1878 11.8147 +2796 6 40.68 12.1827 1.56051 12.2683 5.96873 16.2718 +2797 4 41.5968 12.2158 1.84207 12.0551 -6.37233 -9.83141 +2798 4 40.2741 12.5174 2.36876 -21.9125 -2.35909 -10.0625 +2799 6 47.3781 8.09655 26.7608 82.0606 26.064 -7.54845 +2800 4 46.666 7.67998 26.3919 -67.6244 -33.3987 -26.4118 +2801 4 48.0445 8.01522 26.0221 -12.6559 5.80771 33.8866 +2802 6 35.8947 30.7223 38.5098 17.2216 52.6179 -38.6143 +2803 4 35.6523 29.9703 39.0072 10.7188 -28.2359 27.6772 +2804 4 36.8587 31.0199 38.5623 -37.3038 -25.1724 3.03639 +2805 6 51.3054 23.2176 32.4969 -40.2617 11.1267 -4.72183 +2806 4 51.571 23.9803 31.9692 8.10126 9.10595 3.65824 +2807 4 52.0738 22.7076 32.6523 27.5758 -14.8312 4.00399 +2808 6 30.6066 4.44965 39.6625 0.615077 -4.04577 -5.4494 +2809 4 30.9728 3.64581 40.0124 3.38991 -22.1323 -0.234101 +2810 4 30.7691 5.02119 40.3987 0.467535 29.3806 6.08815 +2811 6 35.2584 29.6988 2.86074 -18.8762 -20.4699 -30.2285 +2812 4 35.7444 29.7805 2.00551 -3.31399 -2.84145 17.507 +2813 4 34.478 29.0852 2.62897 29.9452 30.586 13.9144 +2814 6 50.3064 26.1399 9.38994 -11.2342 14.6262 -3.47403 +2815 4 49.9288 26.8854 8.86032 11.0364 -25.2497 6.23881 +2816 4 49.6695 25.4035 9.37359 7.94529 9.32604 -3.86417 +2817 6 50.1026 36.8163 26.4125 -14.5138 -5.51826 -11.285 +2818 4 49.5888 36.0167 26.6617 3.79204 13.187 5.56915 +2819 4 50.2319 37.3727 27.1922 -3.20057 1.11223 6.19844 +2820 6 40.3045 23.9511 38.5442 56.3682 27.7758 -3.16545 +2821 4 40.8125 24.7624 38.7991 -6.5383 -29.3065 -12.768 +2822 4 39.4568 24.2221 38.8139 -44.6373 -1.162 12.0349 +2823 6 24.9504 10.7612 30.6561 23.3702 -4.90777 36.4738 +2824 4 25.6234 10.7245 31.4083 -25.7901 9.07318 -40.0098 +2825 4 24.9126 11.6687 30.2959 1.4184 -10.5997 2.42613 +2826 6 5.89627 1.02238 5.41014 -10.9637 -3.10309 -8.95081 +2827 4 5.14436 0.409378 5.47088 11.7326 -0.810065 6.31118 +2828 4 6.70289 0.529043 5.60145 -0.696658 -1.4992 -0.407558 +2829 6 44.282 29.3718 26.2736 69.4655 -24.0165 25.5627 +2830 4 43.5561 29.7046 25.8233 -49.9183 11.7173 -34.3685 +2831 4 44.8903 28.8623 25.6892 -19.9675 5.54095 9.74148 +2832 6 25.3119 10.1784 6.67292 -15.7736 -23.3412 -3.06725 +2833 4 25.6521 11.0537 6.64576 10.6351 24.7362 -4.37451 +2834 4 25.4625 9.79379 5.79618 6.21987 0.326131 1.26241 +2835 6 13.3514 28.0662 2.56722 45.2358 13.6418 17.9819 +2836 4 12.4545 27.8107 2.56105 -32.9681 -11.4511 -11.8173 +2837 4 13.8041 27.7134 1.79344 -6.10921 -0.687749 -0.120894 +2838 6 6.44709 40.2351 18.0254 21.2427 9.30891 -1.39987 +2839 4 6.966 39.4726 17.7533 0.137807 -7.29984 6.20872 +2840 4 5.59682 40.0602 17.6456 -22.1821 0.316247 -4.7234 +2841 6 47.7944 13.5061 2.01255 -17.6425 -30.8617 30.605 +2842 4 48.2016 12.6358 2.19438 -7.04124 7.54818 -3.24284 +2843 4 48.4122 13.9735 1.50015 28.8905 20.8749 -24.4455 +2844 6 13.5944 20.2974 2.4458 20.0315 11.2691 18.6487 +2845 4 13.7883 19.6075 3.10831 1.39134 9.87367 -8.40212 +2846 4 13.0064 19.8713 1.85297 -21.5499 -10.3053 -19.2062 +2847 6 15.2336 0.850818 36.6661 8.37652 40.6516 -23.9146 +2848 4 15.3117 1.46746 37.4264 -6.40063 -24.0213 -7.24367 +2849 4 15.3514 1.51981 35.909 -6.71396 -40.605 26.1829 +2850 6 33.5971 35.2491 15.0847 71.6425 -10.6997 11.4711 +2851 4 33.8969 35.3297 16.0058 -20.0956 -0.49545 -2.4869 +2852 4 34.508 35.0431 14.6807 -47.978 4.31732 -2.67502 +2853 6 21.7981 9.23698 0.429299 24.0185 -25.5324 29.6504 +2854 4 22.426 9.07175 41.6424 8.6426 -4.20457 -11.04 +2855 4 21.1884 9.81045 0.032847 -35.1273 25.1593 -17.3244 +2856 6 38.1453 27.4709 3.0333 47.9463 -55.6761 10.6859 +2857 4 37.7532 27.3037 2.19157 -17.0599 1.14667 -24.2168 +2858 4 37.8405 28.2288 3.44687 -27.291 50.0057 16.1216 +2859 6 38.8714 27.215 11.7709 41.141 -36.7506 -15.3879 +2860 4 38.9285 26.3434 12.2193 -14.3396 10.7389 0.963039 +2861 4 39.5886 27.0941 11.0922 -22.6073 11.6268 16.0227 +2862 6 29.8734 41.5737 28.6987 15.2279 35.2113 -10.5566 +2863 4 28.9552 41.3162 28.7047 -13.1778 -5.77603 2.88395 +2864 4 29.9141 0.263017 27.9132 -0.896253 -12.9147 16.3719 +2865 6 34.03 8.70777 38.0687 38.5763 27.6628 16.1728 +2866 4 34.8607 8.18924 38.1985 -14.88 11.0383 -8.6682 +2867 4 33.3419 8.15213 37.7593 -24.3719 -27.4308 -8.08559 +2868 6 38.8091 27.3495 30.6738 6.32435 -21.1782 -4.52762 +2869 4 38.5154 26.4386 30.4378 -1.34454 21.7952 1.35616 +2870 4 38.3686 27.5808 31.4849 -11.9448 1.82739 7.69603 +2871 6 41.6473 17.269 36.3639 7.45605 15.5752 1.52238 +2872 4 41.3137 17.162 35.483 -10.4634 0.342165 -15.0979 +2873 4 41.7169 16.3923 36.7151 5.72978 -18.5967 8.16978 +2874 6 30.7243 26.977 35.2074 -15.5404 -28.2563 -3.1326 +2875 4 31.3953 27.4345 34.7177 18.5093 15.4635 -5.31058 +2876 4 30.2206 27.5565 35.766 -0.690558 20.2492 9.56945 +2877 6 47.5414 4.09198 27.2867 -2.42911 13.6608 18.2544 +2878 4 46.636 4.37242 27.4325 -10.4037 -2.52064 9.15115 +2879 4 47.5606 3.99786 26.3497 6.55325 -3.96267 -23.0579 +2880 6 20.946 8.39203 7.27322 -27.8597 -45.7319 -0.818331 +2881 4 20.9365 8.74812 8.15774 -0.207227 20.4039 13.5637 +2882 4 21.4094 8.93893 6.67191 21.7448 31.5979 -18.7028 +2883 6 36.8544 13.691 0.855516 -6.96494 -6.58957 -4.7536 +2884 4 37.3845 13.474 1.605 15.5913 2.53244 29.7992 +2885 4 37.0002 12.9032 0.328977 -4.78774 -2.28905 -12.5933 +2886 6 28.5904 20.2994 26.4544 16.2695 -3.42806 -15.5352 +2887 4 28.4835 19.402 26.1318 -1.12761 -3.3858 2.90642 +2888 4 27.7814 20.5406 26.8733 -22.93 6.76513 15.2817 +2889 6 51.6079 16.8571 33.5121 -4.50033 -4.43314 5.93611 +2890 4 51.6159 16.0837 34.101 -3.91985 -0.958274 -7.09147 +2891 4 50.9053 16.6875 32.8669 7.1497 -2.58651 -2.16023 +2892 6 16.2715 32.0073 37.6936 -41.8913 -21.032 -18.7972 +2893 4 16.4093 31.405 38.4555 0.0363557 12.0183 -19.687 +2894 4 15.4977 31.6058 37.1477 38.3353 16.8511 22.6146 +2895 6 14.3407 25.877 13.2155 1.26588 11.3619 -17.2713 +2896 4 13.5013 26.0279 13.6901 5.40221 7.27027 -0.947788 +2897 4 14.4551 26.5608 12.5093 -9.57117 -0.277473 20.5459 +2898 6 54.9749 28.8768 3.30374 1.15612 -53.5629 -1.59986 +2899 4 54.8083 28.9028 2.3467 2.04661 0.129141 5.0455 +2900 4 0.26744 27.9124 3.48546 -12.4506 41.1861 -2.95604 +2901 6 17.22 5.15598 2.57931 -12.7888 -35.846 -9.7104 +2902 4 17.8674 4.52191 2.91459 -1.87097 -9.90488 -4.08214 +2903 4 17.421 5.9071 3.09191 1.36943 25.6696 10.0797 +2904 6 50.6995 33.0507 10.3154 6.59719 15.9916 42.5002 +2905 4 50.6222 33.8517 9.79386 -1.28667 2.08485 -11.8542 +2906 4 50.7575 32.2667 9.79209 -3.80283 -15.7636 -22.9095 +2907 6 28.8826 19.8405 32.3742 18.5732 17.2051 -15.397 +2908 4 29.8373 20.0763 32.2 -31.4986 -11.6613 7.66973 +2909 4 28.4094 20.6578 32.1253 1.55933 -8.77069 7.582 +2910 6 22.4307 12.8248 23.2991 -20.6917 10.5217 33.6658 +2911 4 22.5556 12.3422 24.1574 -2.40655 13.6672 -16.3005 +2912 4 21.7108 13.488 23.4947 18.3613 -16.8762 -11.246 +2913 6 54.7763 15.5394 8.86893 2.10476 3.1215 13.1486 +2914 4 0.465115 15.309 9.51431 10.762 -2.70861 -3.02895 +2915 4 53.9989 15.1653 9.30174 -3.31272 -0.629746 -12.248 +2916 6 10.4518 19.2967 26.1704 43.67 -11.1159 60.7251 +2917 4 11.2502 18.7163 26.2348 -22.5321 13.8961 -6.48776 +2918 4 10.166 19.2541 25.3007 -24.1973 -3.18459 -58.4054 +2919 6 38.6496 20.2998 35.2325 20.2193 -0.813999 -8.63065 +2920 4 39.5955 20.3672 34.9603 -17.6326 -1.16496 9.70871 +2921 4 38.5782 19.6093 35.9099 2.97533 6.68842 -2.65526 +2922 6 17.4906 18.0487 15.2499 -10.3405 45.0299 20.0184 +2923 4 17.3837 17.5615 14.4531 -8.22833 -15.0257 -32.2828 +2924 4 17.2318 18.9864 14.9797 13.5676 -28.3997 10.204 +2925 6 29.6331 0.960567 26.2796 -25.6031 -26.3316 -72.4206 +2926 4 29.3216 1.74647 25.7973 3.40072 6.61544 23.4347 +2927 4 29.2407 0.266373 25.6265 23.6279 16.4272 47.4057 +2928 6 30.4665 12.6849 28.2971 -10.7965 -27.9245 1.17671 +2929 4 29.8272 13.0822 27.7097 -1.40549 16.7134 -9.61387 +2930 4 30.1324 11.7665 28.3519 9.60572 9.94425 5.65357 +2931 6 36.6695 22.1225 33.3577 39.6017 -11.6369 -25.7224 +2932 4 37.5338 21.6663 33.4931 -10.4393 24.3252 -8.31461 +2933 4 36.1732 21.6976 34.0074 -34.1256 -9.27026 38.9845 +2934 6 34.8672 22.4666 14.3113 -12.0535 -16.0605 -66.2467 +2935 4 34.0349 22.4515 14.7407 -19.1997 11.5289 38.0952 +2936 4 34.5417 22.174 13.4128 25.6484 2.69091 24.3313 +2937 6 15.5262 9.60919 7.44527 49.3682 -27.3699 -19.0187 +2938 4 16.547 9.52246 7.26069 -54.7763 6.57045 5.33777 +2939 4 15.1277 8.71762 7.26288 7.76902 16.5773 17.8238 +2940 6 21.8158 28.0339 19.8054 -4.91607 2.79332 -16.2053 +2941 4 21.8614 28.4614 20.6522 -2.04715 7.82991 15.4338 +2942 4 20.8734 27.9328 19.6183 -0.9528 -10.4666 6.26348 +2943 6 34.5348 24.4247 2.43569 30.4222 -68.2311 14.7367 +2944 4 34.4753 23.4054 2.32054 1.69344 45.6403 0.121788 +2945 4 35.3397 24.4934 3.03523 -29.9154 15.8849 -16.545 +2946 6 12.599 20.9348 33.4989 -13.8827 -5.0407 19.8786 +2947 4 11.7591 20.6911 33.9854 14.8004 1.51093 -27.4282 +2948 4 12.4712 20.9089 32.5331 -6.4324 -2.96843 13.903 +2949 6 45.7737 31.1538 8.70434 -2.26925 11.3362 1.64289 +2950 4 45.9542 32.0869 8.96415 -8.39554 -11.7705 -15.6468 +2951 4 44.8313 30.9442 8.82297 5.93432 7.3758 2.64979 +2952 6 15.4817 22.5529 30.1787 5.69125 -30.6905 2.54506 +2953 4 16.2669 22.9885 30.4865 5.73919 23.8488 1.47991 +2954 4 15.7828 21.6299 30.2043 -15.5749 7.04719 -4.74998 +2955 6 39.7421 17.1743 38.4094 21.5551 17.0277 -9.47446 +2956 4 39.5031 16.7163 37.59 -3.21419 -6.16335 13.1695 +2957 4 40.5012 17.7258 38.123 -12.3818 -10.233 9.13463 +2958 6 13.9944 24.6739 0.675362 16.6213 17.4065 1.77653 +2959 4 14.3534 24.6315 1.57006 -7.52322 -5.04497 4.60086 +2960 4 14.2363 25.5684 0.403337 7.11699 -3.23043 -4.31609 +2961 6 31.5223 19.5616 3.57151 -53.5885 6.24325 20.3398 +2962 4 30.9852 19.2876 4.35912 8.49606 10.2921 -25.2864 +2963 4 32.3806 19.3906 3.88708 44.0272 -8.41539 -5.41474 +2964 6 36.1052 25.07 19.4414 -58.1964 5.4792 30.944 +2965 4 37.0178 24.9674 19.4291 53.7837 8.57858 1.17104 +2966 4 35.8724 24.6048 18.6565 -11.4284 -6.26335 -25.0938 +2967 6 51.6856 17.6883 14.8068 3.37141 18.4291 36.2611 +2968 4 51.7159 18.5692 15.274 12.631 -26.1695 -13.2311 +2969 4 51.0805 17.8845 14.1157 -15.036 4.32684 -29.7308 +2970 6 37.7054 27.4905 38.1961 21.1085 51.9404 -4.50496 +2971 4 37.7442 26.8536 37.5026 -5.7586 -24.9449 -15.2301 +2972 4 38.1753 28.2651 37.7886 -14.569 -23.1779 14.5181 +2973 6 34.7911 13.8542 30.7834 63.814 8.34946 -38.9004 +2974 4 35.1479 14.6416 31.2053 -8.52888 3.60926 11.6955 +2975 4 33.9958 13.5796 31.1473 -54.5977 -12.3598 32.1143 +2976 6 19.6332 37.3754 39.9698 -24.3625 -2.8653 -8.02349 +2977 4 20.5737 37.5051 40.1221 10.6449 -2.37562 -1.97502 +2978 4 19.476 36.9037 39.1231 9.83703 4.21653 7.37417 +2979 6 40.9393 34.0697 21.4586 2.1394 -11.0927 -27.2527 +2980 4 41.1855 34.0244 22.3739 -0.995015 -5.02364 12.6588 +2981 4 40.8269 33.1391 21.1809 -5.56645 12.5591 1.05516 +2982 6 32.9542 27.2131 26.5676 21.8236 31.3611 42.3808 +2983 4 33.7455 27.7378 26.9411 -38.3522 -19.3744 -9.62352 +2984 4 33.2804 26.8388 25.7801 14.7034 -8.88898 -37.5519 +2985 6 24.4045 18.6625 15.6046 15.6323 5.3487 0.0952382 +2986 4 23.6496 19.2317 15.7207 -14.8084 -1.4602 1.41466 +2987 4 24.5649 18.2576 16.462 -0.219489 -3.50303 9.55317 +2988 6 29.9663 1.63299 9.06934 -19.1782 58.0281 -13.4952 +2989 4 30.0652 0.728361 9.20589 6.15764 -53.3299 8.23098 +2990 4 29.142 1.69178 8.53744 13.8409 -0.846673 8.85197 +2991 6 31.4884 20.0987 7.87879 28.0207 -11.7442 -56.0977 +2992 4 31.929 19.6692 7.07379 -7.62771 20.3934 38.6055 +2993 4 30.8102 19.4535 8.0257 -16.4635 -8.90407 20.6678 +2994 6 35.0404 3.79156 33.2694 -1.07326 -4.91424 22.8916 +2995 4 34.2545 4.23611 32.9039 10.815 -2.65177 -4.17514 +2996 4 34.969 3.91026 34.2418 -2.62674 -1.77539 -18.1187 +2997 6 43.9504 7.96546 12.9857 17.1829 -21.9111 0.113786 +2998 4 43.3325 7.29581 13.3448 8.44862 12.3123 -3.96012 +2999 4 43.4563 8.73573 12.7333 -15.1408 11.4953 0.0339333 +3000 6 44.1156 32.6759 16.9403 5.31814 23.9263 4.94933 +3001 4 44.7028 33.4557 16.8081 -6.11209 -18.3833 -3.28173 +3002 4 44.1603 32.5425 17.8901 -3.26507 -3.06823 6.73624 +3003 6 40.6044 27.171 19.0399 5.35236 -7.54795 -39.8413 +3004 4 39.9756 26.4797 18.7399 3.73803 11.5815 8.49028 +3005 4 41.0398 27.5246 18.2027 -12.4172 -8.32437 32.3474 +3006 6 46.047 23.2024 29.047 17.2683 37.2743 26.3298 +3007 4 46.6657 23.8797 29.4684 -18.5589 -27.346 -17.4569 +3008 4 46.486 22.3548 28.9238 8.34839 -6.65718 2.80441 +3009 6 42.6215 30.6103 18.862 -5.01232 -15.325 -26.4249 +3010 4 43.5272 30.7476 19.0895 18.324 11.0008 12.4889 +3011 4 42.704 29.9429 18.1625 -17.0641 3.12823 2.85026 +3012 6 36.1251 10.8932 23.2678 23.6581 36.1082 4.04534 +3013 4 35.2523 11.2865 23.1129 -2.80799 -1.69562 1.02392 +3014 4 36.6983 11.6913 23.4963 -28.2294 -33.6871 -7.78786 +3015 6 13.7386 31.5223 15.7271 -4.49361 3.73805 -16.8081 +3016 4 14.6779 31.7192 15.7387 3.94655 -1.56597 5.72926 +3017 4 13.381 32.0318 14.979 -1.5565 -4.12563 8.0657 +3018 6 33.1703 41.4275 27.7797 10.5813 -15.702 68.4674 +3019 4 32.9714 0.101499 27.0951 -7.66273 31.9341 -41.1766 +3020 4 33.2579 0.043937 28.6255 4.60937 -17.5422 -27.6682 +3021 6 32.9019 22.9042 31.4856 -22.5274 37.748 -5.90861 +3022 4 32.2895 23.1741 30.7829 6.44322 -22.1433 -13.1277 +3023 4 32.7242 23.6662 32.0583 13.0029 -8.58894 11.8377 +3024 6 27.6559 16.8629 6.38841 0.759442 -6.33883 29.8789 +3025 4 27.8611 17.2083 5.54221 8.69809 17.4791 -25.8043 +3026 4 26.8031 16.4594 6.24591 -13.957 -6.38022 2.63501 +3027 6 47.2651 11.6173 26.0576 8.33461 35.0159 47.6166 +3028 4 47.0912 11.6838 27.0214 -5.10661 -22.4254 -22.6877 +3029 4 47.7461 12.4597 25.9756 -3.10554 -9.06377 -24.8427 +3030 6 27.5595 7.06242 7.64189 36.0057 -29.1625 5.70238 +3031 4 26.7484 7.49683 7.83093 -25.0876 11.7282 17.2448 +3032 4 28.0841 6.86482 8.45622 -15.7481 15.6684 -17.1357 +3033 6 39.8009 9.06823 11.973 -19.1879 4.0297 -12.8881 +3034 4 39.4826 9.27056 11.0665 6.39012 -4.37616 15.6201 +3035 4 38.9894 9.1094 12.5089 2.28999 7.64442 -1.09803 +3036 6 18.1977 33.4656 36.103 -47.2434 1.22325 7.58723 +3037 4 17.6693 33.9565 35.4324 13.0563 -6.22307 9.58411 +3038 4 17.491 33.069 36.7104 31.5801 5.82297 -20.8408 +3039 6 37.1917 26.5507 0.720984 -4.45309 15.6177 5.32368 +3040 4 37.3846 25.6567 0.44907 -1.85313 -8.64798 -1.56679 +3041 4 36.2207 26.6114 0.739208 8.96605 -1.46339 -9.13916 +3042 6 44.1887 19.6251 36.8885 40.0452 -6.58607 -3.19327 +3043 4 45.0262 19.1233 36.6753 -25.2412 9.90919 11.1214 +3044 4 44.4881 20.5478 36.9825 -7.95545 -4.32402 -1.12283 +3045 6 27.7744 6.35339 35.6933 13.1235 -8.00403 1.40836 +3046 4 27.1655 6.97567 35.3121 -8.4989 9.93248 -6.95364 +3047 4 27.2748 5.53908 35.7675 0.865215 -2.72076 5.22838 +3048 6 34.7673 16.4826 20.8897 25.0208 -26.1622 5.09639 +3049 4 35.5801 15.8751 20.9364 -40.3091 28.8833 0.638889 +3050 4 34.1629 16.1653 21.5964 8.34467 8.45669 -12.6288 +3051 6 39.0349 20.9701 40.4369 -35.0548 -83.2732 -20.3586 +3052 4 38.7355 20.0763 40.8679 21.616 52.9309 -20.1646 +3053 4 39.3277 21.5521 41.0958 10.956 28.6509 41.127 +3054 6 10.8075 27.9275 1.66251 45.0798 11.5101 -39.3642 +3055 4 10.1207 27.6506 2.20454 -46.3214 -11.9312 37.0665 +3056 4 10.864 28.8887 1.77269 -0.956148 -2.75571 -0.87801 +3057 6 47.0235 23.1304 13.2457 -34.1648 -14.46 -9.62139 +3058 4 47.6809 23.5773 12.718 7.19949 7.22116 -4.18429 +3059 4 46.2703 22.9258 12.6132 27.3011 3.73645 28.26 +3060 6 34.5862 28.4037 10.6629 -11.4192 -4.75939 1.42695 +3061 4 34.4799 27.7252 11.3319 -5.35328 -3.69815 4.40234 +3062 4 35.5403 28.4214 10.6073 9.29856 11.2923 -14.2157 +3063 6 3.3474 17.5828 14.2796 -19.4871 24.8451 -12.2706 +3064 4 3.54237 16.6973 14.5399 7.15819 -24.2504 13.4427 +3065 4 3.84281 18.1577 14.8755 9.98901 -5.90389 -1.38432 +3066 6 27.7213 11.5993 7.52196 5.39723 39.0715 -5.17771 +3067 4 27.6701 12.604 7.61024 4.43832 -37.6789 -1.1729 +3068 4 27.2296 11.2227 8.25132 -2.72363 -3.1191 8.53492 +3069 6 41.4314 28.3382 9.01837 19.0589 -0.973961 -18.7609 +3070 4 40.8555 28.7961 9.62238 -6.75468 20.1798 6.66135 +3071 4 41.7073 28.957 8.28743 -10.8025 -14.2077 17.7393 +3072 6 42.0854 4.7797 8.18851 -21.257 14.5957 -52.3899 +3073 4 42.0432 5.70949 7.81908 14.9695 -22.9802 20.9203 +3074 4 41.8649 4.22501 7.38905 12.6142 12.8494 32.4876 +3075 6 28.4682 8.6325 40.3242 -61.7219 6.47809 -5.55454 +3076 4 27.7379 8.57122 40.9835 27.869 -4.13123 -2.00049 +3077 4 27.8882 8.69791 39.5144 34.8971 -1.31486 9.68376 +3078 6 0.711352 18.2475 15.2828 -1.03732 14.0577 26.4962 +3079 4 1.6037 18.2498 14.9622 18.0256 -6.96047 -13.9963 +3080 4 0.201613 17.7329 14.6701 -10.6254 -13.4061 -11.9404 +3081 6 7.11345 16.2289 40.4432 8.45023 -35.9074 47.1296 +3082 4 7.17312 15.3057 40.7986 -0.221024 11.0765 -27.8146 +3083 4 7.22051 16.6703 41.3088 -5.23596 22.4775 -22.5048 +3084 6 41.0858 8.62552 20.9048 11.0684 -11.3616 26.0286 +3085 4 40.3918 8.42716 20.2762 -10.0062 9.73992 -12.3328 +3086 4 41.3944 9.53753 20.8124 -4.81268 6.06535 -10.7329 +3087 6 31.7073 7.42286 37.542 -14.8479 -9.90339 6.69006 +3088 4 31.4959 7.12404 36.6506 2.47263 0.526998 -6.01676 +3089 4 30.9335 7.11441 38.0458 14.4773 7.59586 -0.291785 +3090 6 40.7266 11.6476 25.425 -35.4896 13.4329 -16.1803 +3091 4 40.7395 12.5913 25.6925 9.9362 -18.5419 -7.18222 +3092 4 41.5423 11.2236 25.6435 22.7694 -4.71413 12.394 +3093 6 29.8665 30.1579 6.66307 26.6562 -4.16721 8.5177 +3094 4 30.5555 30.7343 6.31583 -2.18777 1.73834 -10.5199 +3095 4 30.3573 29.3259 6.76714 -13.2281 -1.59651 -6.45815 +3096 6 40.8439 24.5837 5.68012 15.8615 33.1962 -4.14396 +3097 4 41.3457 25.4223 5.9023 -8.27611 -29.5734 -8.52614 +3098 4 40.1119 24.5659 6.27901 -12.3156 -1.80355 11.8721 +3099 6 34.3917 9.09675 20.4219 17.6262 -1.15942 17.9162 +3100 4 33.57 9.43601 20.7884 -5.86563 4.88571 -3.34935 +3101 4 34.2167 8.80099 19.5352 -13.2656 -6.03918 -15.2606 +3102 6 18.2311 33.5548 26.5354 9.60899 -55.578 -54.4315 +3103 4 19.159 33.2107 26.4405 -23.3884 24.4218 8.45675 +3104 4 18.1621 34.044 27.3085 3.33799 34.4716 53.9641 +3105 6 28.9072 17.4193 26.7965 8.90265 -1.34032 10.3526 +3106 4 28.3267 16.8801 26.2506 -9.53448 5.67773 -5.57268 +3107 4 28.3756 17.7646 27.5432 9.63981 -8.23286 -8.72686 +3108 6 50.4255 35.5446 18.192 14.112 9.6817 -2.74072 +3109 4 50.5661 35.3326 17.2487 -8.6314 -7.47676 15.7559 +3110 4 50.5766 34.7477 18.7329 -11.9848 3.75846 -10.2286 +3111 6 2.99463 21.5653 31.4474 1.68271 -21.0005 -22.757 +3112 4 3.33698 22.262 30.8385 -11.1525 -11.1618 12.076 +3113 4 2.83901 20.7479 30.8788 5.9339 29.1288 19.4027 +3114 6 36.1811 18.7457 8.60665 26.0746 50.7707 2.54435 +3115 4 36.1969 17.9289 9.04749 -6.79937 -48.2248 12.3681 +3116 4 35.6147 18.7828 7.85483 -18.853 -7.00319 -22.0811 +3117 6 20.2934 6.48366 33.7248 -33.7925 -21.1439 9.08779 +3118 4 19.8228 6.33509 34.5702 11.9648 11.0481 1.53323 +3119 4 19.9109 5.73333 33.234 17.8653 6.32962 -8.93867 +3120 6 14.0016 30.5326 6.65439 -2.06342 0.226434 14.1624 +3121 4 14.6658 31.0189 7.18657 -8.4774 -5.82658 -13.2159 +3122 4 13.1556 30.6664 7.11082 5.19683 1.19435 -6.65694 +3123 6 36.2738 16.4523 35.7634 28.7444 28.7466 -1.25628 +3124 4 37.2529 16.3082 35.8444 -30.8138 -2.80693 3.80535 +3125 4 36.1869 17.4417 35.6433 -1.25715 -33.4762 0.326736 +3126 6 45.8255 37.6646 9.68707 16.0609 -41.2042 -13.6418 +3127 4 45.4852 38.2919 10.2717 -20.4348 34.8513 25.7777 +3128 4 46.231 37.0083 10.2774 7.06244 2.74597 -12.4723 +3129 6 47.4229 17.9968 27.6368 -1.79372 -57.0164 -4.60636 +3130 4 47.566 17.432 26.8065 -4.8869 24.4286 27.8294 +3131 4 47.3631 17.3546 28.4089 6.87022 22.2846 -25.0829 +3132 6 25.9574 18.2976 0.964228 23.0858 -4.77958 -10.3735 +3133 4 26.3734 18.9022 1.60725 -19.9671 -4.02324 -2.33442 +3134 4 24.9961 18.2982 0.948557 -9.32218 6.60301 10.8105 +3135 6 27.3657 22.4026 4.28337 1.04907 -15.9856 -17.2206 +3136 4 27.2658 23.3197 4.47064 2.83879 26.7243 10.1579 +3137 4 27.3462 22.4079 3.3181 -1.05974 -10.8362 7.50108 +3138 6 3.39902 3.84297 27.6033 -32.797 -16.937 8.3321 +3139 4 3.87422 4.64571 27.4715 26.6916 15.5682 -1.1402 +3140 4 3.96055 3.06079 27.6076 7.92228 2.5358 -5.38712 +3141 6 45.3564 27.6573 28.835 13.8657 -6.64535 19.4164 +3142 4 44.592 27.1099 28.6295 -10.1072 2.65107 -0.516215 +3143 4 45.3903 28.3299 28.161 -2.22034 5.33578 -9.67936 +3144 6 28.3928 32.384 16.2149 35.1766 -7.36337 1.61596 +3145 4 29.2284 32.2059 15.7054 -23.0821 5.0916 11.0276 +3146 4 28.7076 32.6186 17.1078 -8.03404 1.42552 -9.59962 +3147 6 9.90485 33.8293 13.0286 10.5996 -3.42126 36.647 +3148 4 9.63365 33.2371 13.7754 2.50037 15.8816 -14.8106 +3149 4 9.32864 33.6931 12.2897 -16.1444 -6.90665 -19.0975 +3150 6 38.3335 26.6343 14.9205 -0.551684 -24.4487 3.86314 +3151 4 38.658 25.7334 15.149 1.53578 20.736 -5.06851 +3152 4 37.3858 26.5974 15.0972 1.00556 4.30146 -0.183996 +3153 6 31.3571 16.3836 4.2445 -16.7299 -18.7641 16.8138 +3154 4 30.5501 15.9079 4.56795 14.9054 8.61271 -6.80276 +3155 4 31.2311 16.4593 3.29715 -1.72501 9.16645 -9.12782 +3156 6 6.17482 3.39637 6.55833 17.6941 29.4886 56.031 +3157 4 6.41103 3.08651 7.49149 -7.06328 10.7723 -41.2395 +3158 4 5.9143 2.63963 6.07247 -2.51266 -29.5732 -15.1374 +3159 6 42.5954 13 5.61529 2.6815 -10.2341 6.00586 +3160 4 42.2228 13.83 5.89445 -1.70762 9.74234 -1.3058 +3161 4 43.4476 12.9425 6.06763 3.18432 -3.38396 -9.63491 +3162 6 41.0469 31.4032 33.8032 -2.41258 31.7421 -2.74763 +3163 4 40.7074 31.3974 34.7214 7.44932 1.1292 -16.4995 +3164 4 41.1575 32.3688 33.5162 -1.31614 -41.8694 16.6901 +3165 6 52.8576 12.0626 26.2641 9.5895 -24.4248 -55.9842 +3166 4 52.4684 12.727 26.7939 -19.7064 26.0739 18.5009 +3167 4 52.6066 12.2568 25.3043 12.3637 -4.77707 33.6793 +3168 6 39.2086 4.29542 29.0724 8.4008 5.1904 -7.5125 +3169 4 38.4444 4.85752 29.2861 11.0986 -5.7068 1.32154 +3170 4 39.9986 4.64958 29.5231 -9.05665 -5.78587 -2.57989 +3171 6 3.65769 27.0104 11.285 -33.2394 -3.70913 -3.8751 +3172 4 4.59992 26.8829 11.3514 17.6792 2.33561 -5.11125 +3173 4 3.4519 27.7953 10.7423 10.2361 0.60791 3.91121 +3174 6 41.5441 29.6402 25.2654 2.79284 -4.6021 22.0238 +3175 4 41.8464 29.7038 24.3667 4.04268 2.71218 -16.2057 +3176 4 40.7127 30.1073 25.3399 -6.11251 5.69311 -9.79107 +3177 6 50.4754 27.4974 30.671 -6.87832 -12.1873 7.27551 +3178 4 50.0778 27.1279 31.4799 3.22248 2.82006 -4.01445 +3179 4 49.7824 27.9982 30.2275 0.0461655 4.73 -3.38362 +3180 6 32.7876 33.6322 41.7537 -8.7541 -8.89692 -39.0089 +3181 4 33.1671 32.7559 41.8028 5.47994 -11.5785 5.15438 +3182 4 32.9083 34.029 0.675063 4.83491 15.974 33.6037 +3183 6 5.9806 9.64323 7.93715 4.3965 6.41539 -15.2951 +3184 4 5.77829 9.93579 8.8312 0.6559 3.73469 4.68299 +3185 4 6.3228 10.4083 7.4265 1.56495 -8.59939 9.02132 +3186 6 52.7884 25.3949 27.7 -7.43266 -9.74322 -1.44878 +3187 4 52.93 26.351 27.8747 -0.851616 -24.8244 8.41831 +3188 4 52.9998 24.8518 28.4994 7.3809 16.2458 -18.9874 +3189 6 18.6796 23.2043 14.4609 8.49541 46.7244 28.1607 +3190 4 18.697 24.1166 14.872 -21.1178 -26.825 -16.729 +3191 4 19.5981 23.1771 14.2416 15.365 -21.3066 -15.3625 +3192 6 31.2857 9.07887 13.0786 26.2489 -54.2202 -11.3888 +3193 4 31.3193 8.20519 13.5416 -2.63874 16.5358 -10.154 +3194 4 30.7972 9.64602 13.6278 -24.9284 29.9413 31.6235 +3195 6 52.8163 16.833 29.9704 25.4684 -2.46115 -18.7711 +3196 4 53.1785 16.3479 29.2052 -11.8989 0.938692 6.7974 +3197 4 53.5445 17.4528 30.1342 -3.36222 3.81908 9.3955 +3198 6 13.4835 30.6533 11.9137 -46.9609 -12.8402 15.0292 +3199 4 12.8701 31.2475 12.4314 22.3442 -12.341 -15.3642 +3200 4 14.3315 31.0589 11.9363 20.4041 22.2607 2.0467 +3201 6 24.4145 24.6647 11.1793 -22.2983 -41.6602 -10.5575 +3202 4 25.2113 25.1208 11.3859 27.2622 9.38308 11.5927 +3203 4 24.6402 23.6908 11.0915 -11.4513 27.6962 10.6476 +3204 6 11.1203 26.798 5.92715 -0.288466 28.8994 -0.991584 +3205 4 11.4516 26.991 6.8143 4.21529 -7.59652 -0.673238 +3206 4 11.0194 27.7223 5.58288 -7.6649 -30.4822 0.0195949 +3207 6 12.0071 32.3096 4.57291 -4.86243 14.2275 -68.6847 +3208 4 11.7793 31.9281 3.63093 8.01684 14.4954 56.5286 +3209 4 12.2995 33.2463 4.37904 -4.11207 -26.5611 6.70158 +3210 6 6.4322 5.49281 30.4716 35.2368 -18.2726 5.22228 +3211 4 6.85856 6.3256 30.2181 -6.14256 4.86399 -3.96588 +3212 4 5.49729 5.53619 30.4137 -26.8093 16.306 -3.74387 +3213 6 38.1866 39.6 29.3849 -55.2477 -18.0227 -31.7741 +3214 4 37.4363 40.1798 29.0864 28.3626 1.3397 12.8196 +3215 4 37.8398 38.7214 29.0428 28.3274 26.4583 13.0641 +3216 6 52.5811 19.3636 5.41604 51.907 48.1011 -36.5249 +3217 4 52.4834 20.3242 5.17263 -20.1975 -32.0404 8.71389 +3218 4 53.4908 19.2453 4.99747 -31.6145 -20.6418 25.5541 +3219 6 18.3356 9.8205 21.0747 -17.6268 -29.6196 -17.636 +3220 4 17.8021 9.40634 20.3533 -1.88913 9.35392 27.897 +3221 4 19.0546 10.1733 20.5835 25.9839 20.5094 -7.72749 +3222 6 14.4924 41.1161 15.0432 10.1364 3.71296 -9.89663 +3223 4 15.2732 41.1462 15.6022 9.62288 -5.62086 4.10329 +3224 4 13.9031 41.7078 15.5102 -8.32301 1.75038 3.32266 +3225 6 35.9996 23.9069 26.7492 18.6837 -25.8156 -39.8793 +3226 4 35.9246 23.4421 27.5469 -8.45021 -0.659318 44.9575 +3227 4 36.3072 23.1381 26.2025 -8.08285 36.2837 5.17172 +3228 6 35.634 10.4286 26.2543 -16.0886 -36.8378 31.8954 +3229 4 36.0318 10.4196 25.4062 11.0324 6.64788 -31.8122 +3230 4 35.4344 9.46932 26.4326 4.10196 23.0818 -6.20158 +3231 6 45.3004 24.2842 20.2749 24.2383 10.4641 7.4623 +3232 4 45.3515 25.0535 19.6808 2.20237 -7.91345 -3.22769 +3233 4 44.5434 23.7522 20.0895 -20.4117 -5.11737 -13.922 +3234 6 15.8182 39.0515 24.2407 12.965 16.6456 0.954929 +3235 4 15.3741 39.8779 24.5544 7.5658 -17.411 -0.0196462 +3236 4 16.7724 39.3066 24.1247 -29.8541 -4.22386 6.92178 +3237 6 4.60659 25.9073 16.8122 1.83212 2.60998 -1.97709 +3238 4 5.31562 26.4095 17.2499 -5.00617 -6.2898 0.278133 +3239 4 3.79975 26.4302 16.9186 11.5163 2.87992 -0.585475 +3240 6 33.4767 9.9887 32.5701 -44.5277 -5.18869 -27.5725 +3241 4 34.322 10.1593 32.8843 54.6618 16.656 18.5178 +3242 4 33.0203 9.70843 33.3575 -8.70161 -12.0001 8.14623 +3243 6 22.9321 37.514 1.50284 -0.19108 -28.0604 17.8877 +3244 4 23.0149 38.2279 2.13297 1.92014 9.99004 7.14626 +3245 4 22.7552 36.7067 2.06858 1.19451 21.8657 -20.5647 +3246 6 39.1248 20.5474 25.4766 21.2332 -16.8391 26.0428 +3247 4 39.2186 21.3943 25.0643 2.22233 17.645 -5.02625 +3248 4 39.853 20.5019 26.1611 -16.83 0.667515 -19.8449 +3249 6 25.0699 25.071 37.6104 17.3941 16.9986 -26.7924 +3250 4 25.9994 25.4036 37.6322 -19.4928 -16.3283 1.07636 +3251 4 24.8822 24.8366 38.5108 -1.54859 -5.98321 18.8059 +3252 6 12.2108 35.7702 11.4211 -21.274 -0.450661 -24.3109 +3253 4 11.4942 36.1177 10.8268 17.2098 -2.57945 23.3101 +3254 4 12.7534 35.3113 10.7723 8.20233 4.40137 5.7707 +3255 6 42.0318 15.7212 20.1319 23.9789 -4.66934 -19.8056 +3256 4 42.573 15.4482 19.3354 -11.2719 11.6022 18.1956 +3257 4 42.3198 16.6222 20.3614 3.24172 -2.08619 -3.65764 +3258 6 53.203 25.4276 39.527 3.00787 -13.9161 6.63788 +3259 4 53.7641 25.8569 38.8977 9.18601 6.10619 -8.92001 +3260 4 52.4886 26.0297 39.6953 -12.4398 9.9207 3.51955 +3261 6 53.7999 21.7704 1.29423 13.4333 -6.07506 22.1965 +3262 4 54.6908 21.5389 0.969279 -9.57261 -3.1085 -1.99035 +3263 4 53.3016 22.2177 0.619486 -6.56312 6.61298 -22.2093 +3264 6 1.93757 22.4543 20.1748 -8.22485 -1.41006 19.3874 +3265 4 1.60089 23.2534 20.6505 8.04613 -19.7643 -7.74833 +3266 4 2.27012 21.8339 20.8623 2.42307 18.0741 -7.93574 +3267 6 41.1802 16.179 11.484 -8.24259 53.7733 14.6683 +3268 4 40.8475 15.3772 11.8508 -2.32532 -30.9762 7.10209 +3269 4 40.6167 16.8825 11.9353 16.6943 -22.3779 -21.294 +3270 6 17.1967 38.6113 9.60334 5.35995 -1.86267 -8.12923 +3271 4 17.7852 38.6361 10.3521 13.641 -0.452934 12.0217 +3272 4 16.3282 38.6029 9.98982 -18.6262 -0.708432 10.1602 +3273 6 33.1969 12.9538 38.5484 12.352 25.5713 -8.86638 +3274 4 33.6486 13.824 38.4674 -8.05485 -18.2555 -5.8969 +3275 4 33.0335 12.8861 39.4897 4.37007 -7.66636 -4.23751 +3276 6 24.7228 21.6957 39.9776 0.331302 -26.4697 -8.75647 +3277 4 24.5832 21.6143 39.0045 0.235774 0.581704 12.5709 +3278 4 25.2663 20.9218 40.2505 -4.0265 10.6546 -4.86064 +3279 6 13.577 15.5497 27.3411 27.7809 44.9786 27.5516 +3280 4 13.196 16.0821 28.0648 5.30872 -0.0493108 -10.0398 +3281 4 12.9031 14.935 27.2057 -29.8548 -39.4113 -11.0219 +3282 6 24.6863 18.7248 9.26482 -8.80414 -2.51529 14.0236 +3283 4 25.3563 19.2311 8.7609 -6.6335 -0.338001 12.1858 +3284 4 24.3761 19.0911 10.1338 17.243 1.91927 -22.7003 +3285 6 10.9743 8.21046 0.042398 -18.7759 13.8117 62.0104 +3286 4 10.3469 8.74796 0.639501 28.6352 -16.9877 -21.8389 +3287 4 11.7753 8.08291 0.592641 -4.28958 7.52309 -10.9298 +3288 6 15.7499 31.9609 31.3743 -17.6212 -20.5964 15.467 +3289 4 14.8817 31.9157 30.9761 -10.6343 5.00824 -7.09118 +3290 4 16.0827 32.8403 31.1978 10.1106 0.369155 -2.88897 +3291 6 20.3726 39.1695 21.6147 20.5981 -29.5513 41.0934 +3292 4 19.9726 38.3531 21.9994 -5.82675 23.323 -22.8284 +3293 4 21.1172 39.24 22.2595 -11.0324 14.4144 -20.0969 +3294 6 38.8594 19.5251 7.6091 -6.47304 13.0289 -25.1371 +3295 4 38.0017 19.0955 7.57416 -1.20877 -0.517864 1.64758 +3296 4 39.1744 19.3685 8.48411 8.18586 -10.9486 17.219 +3297 6 41.3695 29.7301 21.1465 -57.7285 -14.4296 34.1578 +3298 4 41.7832 29.6286 20.3251 24.9116 3.74799 -36.1007 +3299 4 41.9865 29.9579 21.8177 26.2541 9.18996 12.3917 +3300 6 50.7039 33.8333 22.0593 7.50244 -20.9835 17.6314 +3301 4 50.9654 32.9474 22.4123 -1.20949 24.7473 -8.4765 +3302 4 50.362 33.6446 21.1779 1.66119 1.27804 -3.63001 +3303 6 18.1671 11.1714 14.3658 -12.4278 -6.78987 13.7569 +3304 4 18.0724 11.2679 15.338 -0.312443 2.59996 -20.4321 +3305 4 19.115 11.0923 14.227 4.83391 -0.924272 -3.79066 +3306 6 48.5058 14.2689 15.2513 -36.7782 -21.7282 -18.3567 +3307 4 49.3677 14.5693 15.4148 44.1026 10.3807 8.68918 +3308 4 48.5803 13.5893 14.5426 -8.44167 10.5166 12.8885 +3309 6 32.9801 15.74 8.25484 19.5805 1.81858 6.30948 +3310 4 33.8151 15.5666 7.78828 -7.72407 0.576521 2.61047 +3311 4 33.2057 15.7253 9.21147 -5.47651 1.26655 -15.0149 +3312 6 42.9141 4.85593 18.7596 35.6338 16.8786 18.3104 +3313 4 43.0674 5.82698 18.891 -14.0493 -22.2454 -3.89051 +3314 4 43.7794 4.50634 19.0974 -23.5505 0.71427 -17.3058 +3315 6 10.488 23.7131 33.4436 27.6073 45.1219 -14.7699 +3316 4 10.638 24.6985 33.3892 -15.3766 -28.1208 6.63949 +3317 4 11.1638 23.4099 32.8243 -6.46894 -14.1785 5.09081 +3318 6 1.12582 20.0662 11.2775 2.81918 8.09367 56.8435 +3319 4 0.488344 19.3589 11.407 -2.14544 -6.99577 -20.9797 +3320 4 1.17571 20.424 12.22 2.69463 -2.11621 -44.733 +3321 6 1.50824 39.5346 14.3079 -5.25271 -28.0543 15.9462 +3322 4 0.868346 40.1487 14.6984 3.61457 -0.641003 -8.28938 +3323 4 1.2571 38.629 14.6571 12.5115 33.2201 -10.0417 +3324 6 8.3332 21.6069 14.1357 -16.8636 -16.8509 36.8071 +3325 4 8.17334 21.0976 14.9962 5.25323 23.3985 -29.627 +3326 4 7.56323 21.4407 13.5807 -3.95337 3.79773 -2.56685 +3327 6 7.16177 13.3249 38.2255 -6.34169 -18.8056 -1.32195 +3328 4 6.69256 13.0329 37.4043 9.76156 12.0715 20.3406 +3329 4 7.43529 14.2522 38.1581 -0.0118119 -11.8895 -14.491 +3330 6 46.6212 1.64167 18.6867 -0.0463537 -24.1078 41.7639 +3331 4 47.541 1.5611 18.992 -0.862753 9.16913 -10.8716 +3332 4 46.1606 1.36736 19.5239 4.43612 14.9978 -24.7224 +3333 6 4.08147 8.39338 14.788 26.1694 13.8207 2.32184 +3334 4 3.41636 8.28931 15.4347 -29.1417 0.0985708 23.0338 +3335 4 3.90156 7.69349 14.1818 -2.47935 -14.3959 -27.3016 +3336 6 47.5712 36.5372 17.8422 14.6219 44.3363 14.3039 +3337 4 47.1691 35.7037 17.6938 -6.70251 -40.3849 -9.96305 +3338 4 48.5299 36.4434 17.8412 5.708 -14.7801 -1.83759 +3339 6 48.7177 32.6293 3.61477 24.5557 -7.82504 -30.2396 +3340 4 49.3183 32.0587 3.09719 0.221751 18.4164 7.83871 +3341 4 48.4066 32.0299 4.25286 -21.3126 -17.4552 36.5328 +3342 6 26.8672 34.4113 15.184 7.18591 -12.831 -4.85448 +3343 4 27.1806 33.7337 15.7866 -5.2278 -3.11582 5.08403 +3344 4 27.3382 34.1395 14.3734 -5.71629 20.1707 6.74573 +3345 6 9.99603 27.3398 13.3337 -11.5184 -70.0362 -20.4383 +3346 4 9.96963 28.1856 12.9595 -3.0362 48.3298 -16.8459 +3347 4 9.789 26.7159 12.5598 12.8825 26.2078 29.4693 +3348 6 2.39106 26.8936 37.3456 -18.0299 -5.48602 7.48259 +3349 4 2.24944 26.7597 38.2955 12.6258 0.126767 -1.18485 +3350 4 3.33209 26.9598 37.1993 18.2818 -0.192027 1.55797 +3351 6 33.3384 17.273 36.7956 -4.69576 6.00605 30.6641 +3352 4 32.3777 17.4022 36.9421 6.35755 -1.66054 -12.3647 +3353 4 33.5147 17.1107 35.8745 -6.55426 -0.461729 -19.8283 +3354 6 10.6704 18.7989 9.29568 -2.62714 4.796 -4.28658 +3355 4 10.7729 18.8103 8.31395 -3.57004 -0.312677 18.1362 +3356 4 10.9356 19.679 9.6198 -4.15772 -1.10699 -11.1079 +3357 6 8.58029 27.4085 3.13543 -0.646896 -38.9365 14.7517 +3358 4 8.62134 27.4642 4.10772 -2.35878 18.0768 -8.00568 +3359 4 8.54298 26.4189 3.06204 -3.80038 30.3142 -4.62402 +3360 6 40.6121 33.9148 14.3433 -13.4775 28.2536 -12.7531 +3361 4 40.8898 33.2957 14.9932 8.13038 -23.145 12.8628 +3362 4 40.1237 34.5547 14.8716 -1.64981 1.12342 -7.13376 +3363 6 54.0126 16.7742 13.6402 -25.2384 12.1291 10.4483 +3364 4 54.0311 17.2666 12.8352 12.7766 5.78776 -30.0788 +3365 4 53.1083 16.9555 13.9311 3.38038 0.740926 17.4694 +3366 6 39.1613 38.4947 7.40674 -49.2832 -1.36929 38.9537 +3367 4 38.8094 38.4839 6.52049 1.87105 5.40513 -14.0728 +3368 4 38.3203 38.5292 7.99504 41.7155 2.10662 -28.5328 +3369 6 42.2152 33.6749 29.0207 -49.4578 14.7313 -27.4402 +3370 4 42.0113 34.6279 28.8262 15.7605 -21.0767 3.4048 +3371 4 41.3749 33.2313 28.6743 34.021 9.03137 24.2205 +3372 6 2.84529 0.06018 20.1342 1.75144 -0.125494 -5.27144 +3373 4 2.85876 0.453048 19.2323 -10.3946 -7.40064 8.89792 +3374 4 1.95714 41.5787 20.3005 13.5701 9.63706 -6.70109 +3375 6 24.9846 26.9367 24.435 4.97654 17.1262 30.4362 +3376 4 25.3707 26.0628 24.5275 -2.48626 -13.7157 -10.817 +3377 4 25.1946 27.3852 25.2847 -1.69157 -3.92554 -20.3381 +3378 6 13.6202 33.989 7.00835 -29.3159 10.7937 -13.6787 +3379 4 14.4707 33.6317 6.76766 5.19255 -3.31821 -12.8703 +3380 4 13.1262 34.2356 6.16936 24.7045 -4.21039 25.9053 +3381 6 17.6361 31.8361 3.38698 11.6752 63.8731 -26.646 +3382 4 17.3765 32.06 2.46015 3.81419 -8.12146 27.658 +3383 4 17.5414 30.922 3.45915 -17.4061 -53.1647 5.72422 +3384 6 31.114 29.8463 35.9142 20.4735 12.0385 -23.871 +3385 4 30.4046 29.6578 36.4892 -25.9224 -10.1565 23.4082 +3386 4 31.8798 29.3863 36.2596 4.49336 -0.641295 3.24883 +3387 6 31.4544 1.69927 1.93203 61.0942 61.1307 23.4408 +3388 4 30.847 1.03155 1.81447 -56.5376 -48.8621 -2.33617 +3389 4 31.1234 2.33851 2.60628 -4.67927 -17.7811 -18.4359 +3390 6 13.7206 9.35179 12.308 -20.4886 -14.5553 22.3614 +3391 4 13.8994 10.2254 12.0406 16.2488 33.284 -13.5816 +3392 4 13.1923 9.47724 13.1212 6.47756 -14.062 -7.29461 +3393 6 15.2915 15.1706 12.1407 -39.3514 -20.6771 -15.8676 +3394 4 14.288 15.1355 12.0691 34.6095 3.19954 13.2467 +3395 4 15.5721 14.5705 11.433 2.70369 1.94224 0.817449 +3396 6 44.9298 30.4448 13.0945 -83.0621 -13.8007 20.4391 +3397 4 45.2326 30.6692 13.9612 22.7288 5.76966 14.7184 +3398 4 45.5619 30.4921 12.4362 58.1466 4.79773 -38.6719 +3399 6 35.1494 37.6283 24.8564 -28.9971 -18.9514 34.2227 +3400 4 34.5453 38.351 25.1691 15.7809 -12.2194 -9.31628 +3401 4 34.8969 36.8477 25.46 15.2444 28.3361 -22.0595 +3402 6 43.9018 19.2999 12.9893 -4.23684 -28.8047 14.7243 +3403 4 43.7111 18.3276 12.9437 8.07938 21.0179 -2.3859 +3404 4 44.434 19.3703 13.8064 -8.2748 4.27416 -6.23054 +3405 6 14.1928 27.3824 16.8974 17.9721 24.801 -15.5057 +3406 4 13.3941 26.8971 17.049 -12.9837 -13.2841 -1.45311 +3407 4 14.075 27.8458 16.0392 0.928992 -14.2323 10.6565 +3408 6 5.07867 37.4759 15.7278 -19.2695 5.34987 61.0101 +3409 4 5.83402 37.4907 16.3496 5.41141 -1.20808 -8.02024 +3410 4 5.40595 37.3511 14.8725 27.2981 -13.142 -45.6678 +3411 6 35.4792 36.9736 33.2279 -33.1303 3.22524 14.2013 +3412 4 36.4062 37.0387 33.1707 43.394 6.70104 -6.41693 +3413 4 35.2647 37.5361 33.9926 -10.1497 -5.08286 -5.32556 +3414 6 6.63713 31.7122 32.9951 -15.6769 -13.4095 -29.903 +3415 4 7.30356 31.0631 32.7808 0.413821 -11.0386 -1.85208 +3416 4 7.01801 32.1732 33.7097 9.96672 21.2943 24.541 +3417 6 31.2686 20.2272 25.4717 1.63607 -11.2998 14.888 +3418 4 30.457 20.1188 26.0175 18.7046 8.55246 -6.40474 +3419 4 30.9671 20.3507 24.5747 -9.02709 8.2981 -6.80006 +3420 6 54.9594 26.0897 7.3541 -26.2324 -3.52234 4.1817 +3421 4 54.3149 26.536 6.76189 8.45344 -4.14623 9.81761 +3422 4 54.4064 25.6921 8.06559 9.60693 6.10548 -13.0393 +3423 6 17.8786 35.1581 24.3912 -48.4608 -31.2574 -23.2844 +3424 4 17.9034 34.576 25.1672 15.4891 12.513 -1.90366 +3425 4 17.14 34.695 23.8716 34.0055 23.8611 10.1154 +3426 6 49.1404 3.30993 19.753 -11.7437 -5.45724 -22.9314 +3427 4 48.7379 4.07245 20.162 -0.785462 12.6857 6.5087 +3428 4 49.8408 3.03849 20.3377 4.84054 -6.57183 8.59361 +3429 6 30.2791 35.6014 13.4902 -0.275976 1.62471 9.45881 +3430 4 29.4038 35.7322 13.1068 5.01216 -3.78726 -8.18413 +3431 4 30.1007 35.4484 14.4302 1.26073 -0.50544 -4.60872 +3432 6 43.3857 25.8788 41.6729 -28.3599 -13.2186 -4.43344 +3433 4 44.0236 25.6058 41.0289 13.0372 -2.28568 -15.7328 +3434 4 43.8192 26.4334 0.378509 18.4346 21.3926 23.5205 +3435 6 21.1033 23.1572 6.40534 -12.8895 6.60285 13.2505 +3436 4 21.2833 23.9599 6.94372 3.68538 -20.4677 -7.26612 +3437 4 21.2354 23.4378 5.50624 8.61756 6.39287 -19.4039 +3438 6 54.6209 21.1977 19.0953 -9.4905 16.5472 15.3455 +3439 4 0.355231 21.543 19.6762 -10.082 -5.94448 -19.8865 +3440 4 53.803 21.6498 19.4211 22.178 -8.62035 -3.94206 +3441 6 13.8696 38.9444 18.7589 -0.408574 -9.95072 10.686 +3442 4 13.5473 38.5195 19.5701 -4.79749 -3.34053 -10.6661 +3443 4 14.2783 39.7511 19.0654 -4.68159 17.5572 -2.41189 +3444 6 39.1837 2.73799 39.6933 -2.22487 -14.248 -19.2211 +3445 4 38.5048 2.18054 40.1045 3.50502 9.25929 9.72195 +3446 4 39.1752 2.3966 38.7788 -3.09486 7.3066 6.14055 +3447 6 43.2236 33.8218 8.83748 -23.7799 54.6507 -8.87946 +3448 4 43.1776 32.9835 9.22653 -2.14792 -45.6212 21.4927 +3449 4 42.4318 34.327 9.18683 27.5752 -12.6709 -4.85681 +3450 6 23.0768 16.6786 12.1043 19.2201 -8.5648 -22.0864 +3451 4 23.4688 16.2415 11.3109 -7.42341 7.06352 19.0042 +3452 4 22.1329 16.714 11.9048 -3.02708 6.60369 6.72608 +3453 6 40.7875 26.1445 36.3165 -31.0446 26.1707 15.63 +3454 4 40.1182 26.8831 36.2336 22.2291 -27.8038 4.66075 +3455 4 41.0346 25.9172 35.4285 12.0382 -0.567557 -16.236 +3456 6 15.1503 11.6728 19.298 -10.8743 -20.3409 15.6657 +3457 4 15.4707 12.2619 18.6272 13.0208 17.9076 -10.0848 +3458 4 15.518 11.9699 20.1418 -0.780585 5.28883 -4.88637 +3459 6 9.8485 29.8084 31.3808 31.6725 31.0987 -15.032 +3460 4 10.6075 30.172 31.8684 -9.75043 -12.6573 12.7307 +3461 4 9.98584 30.2945 30.5336 -20.1344 -22.7331 8.89086 +3462 6 2.12557 30.0341 25.264 -3.96851 -24.8252 -11.595 +3463 4 2.04755 29.1979 25.7442 2.8488 12.5065 4.07713 +3464 4 2.06741 29.7398 24.3306 5.27272 21.1251 20.17 +3465 6 49.0124 10.6515 7.04668 12.8278 -6.79775 19.6819 +3466 4 49.7765 10.456 7.62014 -4.12072 9.88663 -9.32692 +3467 4 48.4954 9.84699 7.16976 -12.5497 -3.43755 -7.74842 +3468 6 38.6385 34.4247 32.4851 8.7415 15.3068 2.26745 +3469 4 38.2449 35.2411 32.8392 7.79483 -2.42751 -9.0272 +3470 4 38.3877 33.7513 33.1114 -5.41613 -8.85245 5.88093 +3471 6 24.2967 24.7175 4.7858 -13.8074 20.2372 -8.25903 +3472 4 24.5879 23.8747 5.12331 8.49271 -10.4438 10.0312 +3473 4 24.0688 25.3355 5.52385 7.10746 -21.4288 -14.6014 +3474 6 44.0211 23.587 33.7713 -18.8641 -18.6234 -6.9532 +3475 4 43.6265 23.0569 33.047 -3.30007 6.44469 22.3225 +3476 4 44.7839 23.9213 33.3479 32.8249 22.1868 -7.88886 +3477 6 45.135 31.9539 26.6318 17.8742 -16.5206 -32.2352 +3478 4 44.6965 32.0125 27.458 -12.8805 4.46476 28.7394 +3479 4 45.0195 31.023 26.337 -1.34861 17.8758 10.4404 +3480 6 52.0545 6.36303 22.865 -1.87051 -30.929 -4.90791 +3481 4 51.4549 5.58836 23.0553 13.7734 29.2588 0.606927 +3482 4 51.4955 7.14596 22.8951 -3.5837 -3.73437 -5.39564 +3483 6 5.1124 17.7016 30.4663 -17.3022 -2.39818 -4.94531 +3484 4 5.57517 17.705 29.6436 5.33167 -14.42 -26.4334 +3485 4 5.6774 18.2653 30.9495 12.7188 16.8745 32.2475 +3486 6 48.5399 17.0091 6.52669 31.3107 25.6813 -22.3666 +3487 4 48.2466 16.108 6.56632 -4.44525 -18.5722 0.0807757 +3488 4 49.3123 17.0767 5.87973 -32.0368 -4.22047 21.2267 +3489 6 13.8017 31.3286 23.4652 -45.3568 -0.340859 23.461 +3490 4 14.0246 31.2001 24.3905 13.6426 -1.74144 -0.768444 +3491 4 14.5269 31.1963 22.8948 44.8358 -8.96568 -14.3918 +3492 6 28.4984 33.4231 26.025 30.2115 45.129 -4.70205 +3493 4 28.7629 32.7421 25.4284 0.749934 -18.6264 -12.7861 +3494 4 27.7356 33.1626 26.4825 -33.9251 -20.2776 22.3239 +3495 6 9.04101 22.9533 11.0101 4.17271 5.63899 8.67886 +3496 4 9.24243 22.776 10.0879 9.05926 -1.29962 -0.957415 +3497 4 9.84172 22.774 11.5341 -6.79246 0.647577 -9.3095 +3498 6 40.5624 4.0706 26.5792 43.7479 -58.1273 15.512 +3499 4 40.0377 4.03321 27.356 -14.6911 0.39925 31.4188 +3500 4 40.1771 4.74143 26.1095 -33.6389 57.2603 -43.6855 +3501 6 17.0606 37.9689 20.9328 24.9068 -2.83666 19.2437 +3502 4 17.7492 37.7057 21.5806 -0.23423 0.332892 -22.3637 +3503 4 16.3 37.9671 21.4825 -28.3901 -0.1668 6.57955 +3504 6 31.9758 6.36253 14.1925 -47.1359 -2.961 8.2158 +3505 4 31.6652 5.47044 14.4516 -0.57512 5.53961 -9.89258 +3506 4 32.9075 6.27907 14.242 33.1863 -3.34593 -3.73058 +3507 6 29.3613 34.9484 39.6522 -7.7658 6.78361 -10.4711 +3508 4 29.4154 34.7255 40.5688 2.48129 -3.65799 19.6008 +3509 4 28.4079 35.1232 39.5563 9.75382 -5.50564 -9.65046 +3510 6 22.5642 2.93231 32.1024 7.89654 -13.571 4.24933 +3511 4 23.152 3.60479 31.7467 -0.797152 8.5773 -0.128413 +3512 4 22.8746 2.10235 31.6905 -8.86372 14.3523 0.842504 +3513 6 51.7365 19.0888 24.8036 24.4352 10.6631 34.2631 +3514 4 52.2011 19.3182 25.6664 -22.8444 -5.9403 -33.5217 +3515 4 52.2256 19.5376 24.1035 -3.13425 5.18677 -1.50107 +3516 6 32.1309 13.661 24.2221 8.32979 -1.22201 -48.3483 +3517 4 32.1718 13.7834 25.1379 3.34806 7.10631 53.6256 +3518 4 31.2192 13.5434 23.9915 -25.9097 -1.66347 2.1781 +3519 6 9.49478 30.1756 28.7975 -1.02802 7.68553 8.51386 +3520 4 8.9614 29.4447 28.4635 3.13242 -3.87437 -3.11369 +3521 4 9.76139 30.7024 28.0341 -4.99689 -6.39164 -2.13333 +3522 6 31.3017 3.1328 24.0821 -2.56057 -13.3126 7.41322 +3523 4 30.8642 3.97896 23.9468 1.03353 -0.10231 -3.56587 +3524 4 32.1597 3.13825 23.6386 1.18226 10.803 -0.447916 +3525 6 2.13915 19.8328 36.4477 43.9795 26.8161 3.66972 +3526 4 3.0929 19.9274 36.115 -41.9598 -16.8793 8.64164 +3527 4 1.76662 18.9777 36.2517 -5.24508 -9.86619 -11.2286 +3528 6 36.9558 16.7701 14.0992 8.10199 -24.1685 -1.60142 +3529 4 37.0878 17.1202 14.9938 -3.44507 3.84646 -3.58016 +3530 4 37.3137 15.854 14.1066 -5.27996 15.1268 -1.92478 +3531 6 1.82451 11.1811 6.08431 4.75441 9.84221 -14.5701 +3532 4 1.68522 10.3449 6.52934 -2.64515 -5.74712 4.44833 +3533 4 1.45572 11.848 6.66197 -6.16769 2.71123 7.45582 +3534 6 43.1467 36.8536 25.2684 -4.34259 -25.2275 5.76074 +3535 4 42.489 36.6679 24.5813 -1.65581 9.08703 8.09798 +3536 4 42.9757 36.1566 25.9418 7.67001 18.3814 -10.5814 +3537 6 32.1358 5.54258 7.00813 -0.159667 5.03525 -3.02009 +3538 4 31.8447 4.70695 7.37259 1.76357 -8.94122 3.22744 +3539 4 31.6184 6.21523 7.45425 -7.92944 5.35442 3.67752 +3540 6 15.0738 21.498 41.5176 2.48253 -6.99424 4.64434 +3541 4 14.4083 21.441 0.286083 -5.89506 -4.91034 13.0846 +3542 4 14.6326 22.02 40.8608 1.523 7.8898 -22.5967 +3543 6 37.0299 36.0573 5.68999 -1.26402 -4.33671 -4.68257 +3544 4 36.8992 36.8706 5.1864 -9.04185 9.38437 4.54051 +3545 4 36.6368 36.1345 6.57983 4.68584 5.64444 -6.17041 +3546 6 39.6378 22.8733 0.344261 -10.4835 1.90991 -1.04201 +3547 4 39.8967 23.7127 41.8596 6.32696 2.65577 1.7872 +3548 4 39.7641 22.9598 1.30287 2.84221 -4.68177 2.22816 +3549 6 18.471 23.1695 5.24444 18.17 13.8994 5.32385 +3550 4 18.2426 24.0888 5.07969 -12.1406 8.45165 -11.681 +3551 4 19.3434 23.2774 5.65727 -5.17221 -14.3673 2.51868 +3552 6 34.4951 26.4012 0.415196 -24.2262 -21.8504 23.5375 +3553 4 33.9567 27.1096 0.873351 15.2264 -25.8266 -5.88921 +3554 4 34.3584 25.5285 0.919462 6.17703 40.7497 -12.3351 +3555 6 28.1538 26.089 40.6186 -44.0465 -12.7539 23.8091 +3556 4 29.0676 25.9468 40.8623 9.74545 0.451611 8.45277 +3557 4 27.5517 25.6856 41.3354 31.2048 15.0133 -28.9196 +3558 6 41.7541 4.40312 30.2348 -21.1804 7.97019 15.7848 +3559 4 42.5951 3.9554 30.1474 10.5948 -6.90465 6.49815 +3560 4 41.6197 4.66064 31.1807 9.39609 -4.15263 -13.0838 +3561 6 4.45746 8.30422 29.123 17.0584 8.0822 12.8675 +3562 4 3.72424 8.78851 28.7689 -20.5564 0.917363 -10.5697 +3563 4 4.90241 9.00738 29.631 2.39094 -12.8625 -4.67793 +3564 6 12.9051 9.61174 32.1485 9.54391 19.7002 1.20842 +3565 4 12.5238 8.90328 31.6499 -4.6135 -18.7028 0.941221 +3566 4 13.4507 9.29961 32.8815 -5.77341 -6.01915 -0.606497 +3567 6 48.6524 16.2364 1.45279 -39.5117 19.3379 22.5337 +3568 4 49.5656 16.3395 1.57323 44.82 -2.42546 -4.76282 +3569 4 48.322 16.6449 2.29127 -2.06599 -18.2277 -23.678 +3570 6 26.4391 39.9942 21.1964 -5.73 55.7886 4.05886 +3571 4 27.1886 40.6225 21.0926 -13.7426 -7.13397 8.25982 +3572 4 26.7825 39.1793 20.9147 12.833 -38.7313 -7.54244 +3573 6 35.8074 4.09236 9.03492 -45.4698 -15.3304 -15.5709 +3574 4 35.5046 4.67089 8.30824 2.24043 1.80806 6.22839 +3575 4 34.9768 3.81452 9.52186 26.5657 10.3238 -8.47709 +3576 6 52.6895 3.55751 27.8666 50.2867 -19.9176 -34.5196 +3577 4 53.5586 3.5996 28.3549 -33.5645 -3.53647 -1.9565 +3578 4 53.0019 3.22463 26.9489 -24.4009 21.759 36.9675 +3579 6 48.3192 26.6913 27.3954 13.1896 -37.7442 -6.45526 +3580 4 48.9722 25.929 27.4853 -22.116 34.446 0.770506 +3581 4 48.7243 27.4862 27.7371 6.43066 9.80699 11.7315 +3582 6 24.507 4.96042 18.7259 -17.59 -10.4057 14.9036 +3583 4 24.0519 4.20246 19.1729 14.2279 16.3534 -10.8515 +3584 4 23.9406 5.7442 18.8517 8.31711 -9.56192 -0.149656 +3585 6 24.0493 12.473 28.7688 20.4432 11.2466 2.34496 +3586 4 23.2439 12.9627 28.9427 -11.3477 -3.77152 -2.6943 +3587 4 23.8404 11.6087 28.4204 -6.74951 -3.90152 -5.01594 +3588 6 40.1637 27.7353 40.8087 -33.5791 -9.4694 0.953173 +3589 4 40.5641 26.9832 41.236 1.78301 2.25495 0.260865 +3590 4 39.2218 27.4214 40.7917 21.7476 20.7917 -9.34619 +3591 6 11.9335 13.5538 26.9488 -1.21599 4.57236 -11.9259 +3592 4 11.0364 13.8177 27.1576 -7.67129 -6.9102 2.53909 +3593 4 12.2164 12.9501 27.6309 4.70555 -13.4351 6.55277 +3594 6 52.1924 29.5424 41.3942 11.5626 -24.8936 -19.0003 +3595 4 51.8104 30.1965 0.050158 4.44506 23.3375 14.6186 +3596 4 53.1351 29.3771 41.6391 -10.5303 1.44862 4.74126 +3597 6 17.4882 19.0285 39.1853 -8.07927 32.7478 0.0743051 +3598 4 17.5012 19.6463 39.9647 -0.891206 -23.8414 -20.0908 +3599 4 17.261 19.5796 38.3923 8.05332 -16.519 21.1694 +3600 6 46.2326 27.6801 33.704 6.45393 -8.86534 7.23017 +3601 4 46.097 28.3723 33.048 -4.6559 5.79968 -1.93617 +3602 4 45.5979 27.7746 34.4233 -3.33861 16.4707 5.34235 +3603 6 35.8364 29.5448 5.62541 9.64171 -18.9009 -6.27826 +3604 4 35.5566 29.3199 4.72548 3.62776 14.0584 -3.56087 +3605 4 35.3944 30.354 5.86953 -6.57081 16.5188 2.47276 +3606 6 47.2881 25.7744 30.172 -6.62968 25.0044 -44.0548 +3607 4 48.1218 25.8653 29.6696 -5.94381 -7.49802 14.0131 +3608 4 46.6882 26.3745 29.6449 8.85802 -15.1094 17.4745 +3609 6 51.3842 12.359 20.0239 24.4626 17.3052 -5.31346 +3610 4 50.8707 12.833 19.3583 -10.0057 -7.98386 3.51527 +3611 4 50.8448 11.6564 20.3722 -11.0446 -8.70835 7.6307 +3612 6 41.976 18.3776 28.9581 25.2971 -7.26912 -18.3725 +3613 4 42.7018 17.9973 28.405 -17.3573 7.64094 3.96866 +3614 4 42.4517 18.9921 29.5246 -2.74764 -0.293653 0.793262 +3615 6 53.6043 6.48027 7.50524 -23.0657 -32.6432 -30.9738 +3616 4 53.1601 5.59498 7.33399 18.2827 28.6912 7.08019 +3617 4 53.6632 6.576 8.44633 9.6706 -3.87944 16.2616 +3618 6 9.90786 10.6094 26.7582 6.17728 8.73826 28.1859 +3619 4 10.299 10.3755 27.6331 -6.59671 -6.24018 -20.7073 +3620 4 9.65116 11.5299 26.9247 0.732239 -5.98194 -12.944 +3621 6 9.31054 39.3957 29.7756 40.7644 23.7808 19.8799 +3622 4 10.1982 39.3563 30.2561 -34.3316 0.809436 -14.8313 +3623 4 8.83679 40.1565 30.1832 5.55001 -15.1294 -12.8037 +3624 6 33.4099 4.77839 0.03236 -17.6047 -18.7695 14.8321 +3625 4 33.6454 5.53147 41.4176 15.8926 12.9618 -7.52592 +3626 4 34.0969 4.09847 41.8942 -0.186489 10.0102 -3.03658 +3627 6 35.7116 10.6673 34.2398 36.7653 -21.2814 -15.2586 +3628 4 35.2554 10.867 35.0388 -18.8422 0.575424 27.4634 +3629 4 36.4577 10.0619 34.4978 -21.6361 17.9445 -5.28322 +3630 6 15.2039 17.4016 19.1867 13.7018 -34.0248 -48.7675 +3631 4 15.5709 16.9982 18.3093 -23.7907 16.5473 43.0322 +3632 4 14.2523 17.472 19.021 -2.02403 4.48523 -0.714523 +3633 6 17.4757 37.6682 15.4227 -5.7624 0.927264 51.2416 +3634 4 17.0409 37.838 16.3209 3.67045 -5.85113 -35.7653 +3635 4 18.3529 37.3927 15.7202 1.879 4.38305 -13.464 +3636 6 26.263 8.20496 21.7043 -12.9193 13.0258 38.8746 +3637 4 26.2935 8.46487 22.6678 13.4631 -3.74504 -28.0146 +3638 4 25.3122 8.09558 21.5911 -4.90698 -1.77416 -12.6216 +3639 6 0.327844 9.89683 15.4174 -28.4002 -4.57955 -27.8061 +3640 4 1.20252 9.6859 15.1701 33.2298 -8.84956 3.25601 +3641 4 54.8213 9.3498 14.7471 -0.695723 21.8052 24.8209 +3642 6 13.451 40.6616 9.29616 -29.1589 -29.1317 3.11657 +3643 4 12.531 40.2581 9.2528 27.9164 27.237 1.6895 +3644 4 13.9533 39.998 9.7876 1.76749 3.89663 -1.50565 +3645 6 49.5605 25.9144 33.0102 6.77982 -23.7672 54.8124 +3646 4 50.0733 25.5846 33.8473 -25.1648 19.9091 -52.5505 +3647 4 48.6275 25.6453 33.15 14.5478 0.915879 -9.46863 +3648 6 37.0796 40.0419 26.4359 -26.9931 13.9721 12.3681 +3649 4 36.1882 39.5442 26.6099 42.8933 36.2545 -2.50818 +3650 4 37.051 41.026 26.6764 -12.8506 -44.3362 -9.04112 +3651 6 47.9916 17.8545 12.1553 -7.21137 29.6324 -37.7219 +3652 4 47.6652 18.6843 11.7058 6.42171 -29.0319 9.52509 +3653 4 47.7397 17.941 13.056 -8.12129 -2.80141 29.1943 +3654 6 27.9724 29.0571 34.165 6.45289 -21.5611 -2.40729 +3655 4 28.8948 28.8211 34.3683 -10.3018 1.8492 -2.91154 +3656 4 27.944 30.0064 34.1676 -0.713497 24.9251 0.854011 +3657 6 33.997 2.77014 13.2231 -35.3168 39.3397 6.14274 +3658 4 33.7592 2.40426 14.0871 -4.38792 -6.80294 -4.34532 +3659 4 34.7545 2.32608 12.931 40.4814 -27.3629 -5.76242 +3660 6 28.4454 36.033 11.4537 -30.811 -5.98685 22.1865 +3661 4 27.9997 35.3658 10.9161 0.521783 -1.73573 4.3727 +3662 4 28.9676 36.474 10.8303 31.7187 19.1344 -28.008 +3663 6 36.1836 11.3675 28.8638 -20.2526 -8.96451 -46.9053 +3664 4 35.201 11.3136 28.8426 17.393 5.15327 13.3727 +3665 4 36.3619 11.2493 27.8855 5.85658 3.26624 29.9739 +3666 6 24.7946 39.4802 16.9069 19.0937 3.96627 -8.4872 +3667 4 24.3751 40.345 16.9988 -5.97342 -3.52606 0.908874 +3668 4 24.9466 39.3518 15.9585 -10.9099 3.48913 2.54936 +3669 6 49.9504 8.05659 22.8451 -38.4139 -9.47108 -34.4931 +3670 4 49.9375 7.9588 23.7925 -16.1787 -3.75115 16.4902 +3671 4 49.0231 7.8493 22.4633 39.8101 3.17892 24.2331 +3672 6 52.1004 19.3469 10.2236 -1.12118 28.0811 1.24376 +3673 4 51.6057 19.3908 9.40186 -4.74475 -17.9853 -5.36861 +3674 4 52.3066 20.3081 10.2872 8.90847 -30.6944 7.30622 +3675 6 24.8344 15.8907 6.13046 -10.5287 3.62194 6.20212 +3676 4 24.2343 16.3288 6.78807 10.5214 -9.32926 -18.7028 +3677 4 24.4584 16.0701 5.24836 4.34413 4.47582 9.48796 +3678 6 49.3142 23.7074 8.6354 12.7826 -64.5552 32.8663 +3679 4 49.2168 22.9153 9.25307 13.1077 36.9849 -24.4484 +3680 4 48.4233 23.9587 8.46247 -20.5325 16.4959 -12.9251 +3681 6 0.200228 10.6387 32.1899 4.57462 9.08702 -50.3173 +3682 4 1.12405 10.3631 32.1441 4.84637 -6.06001 20.7538 +3683 4 54.8206 10.7585 33.0477 -1.25869 -8.0958 33.7963 +3684 6 12.5866 32.9145 13.2359 -45.84 -1.33101 12.3773 +3685 4 11.7384 33.4448 13.1799 26.1773 -16.8128 -1.90055 +3686 4 13.2757 33.4614 12.9111 20.4647 17.7705 -9.07485 +3687 6 21.729 32.5695 14.1172 -9.28791 -20.3928 5.37861 +3688 4 21.166 33.3661 14.1597 2.78901 -9.86158 3.94413 +3689 4 21.3002 31.8069 14.587 7.27427 31.5827 -10.8786 +3690 6 48.1522 34.8482 27.3304 1.15431 -17.6089 -40.5894 +3691 4 47.5385 35.1725 27.9994 -6.04073 -2.93057 -0.479876 +3692 4 47.6796 34.4132 26.5454 8.99615 21.2578 35.6726 +3693 6 45.6357 31.2393 36.095 -40.8957 20.4658 25.2026 +3694 4 45.8476 31.9489 35.493 1.2761 6.76392 -14.6383 +3695 4 44.8829 31.5945 36.6582 19.8537 -10.4851 -18.3708 +3696 6 46.2846 0.316369 14.3569 -23.6541 -29.5796 11.0344 +3697 4 46.2347 1.24867 14.1822 6.12226 14.592 -0.646978 +3698 4 47.172 41.8876 14.3137 22.6277 5.76419 -11.0491 +3699 6 14.3437 18.9821 40.2104 -25.2995 -33.3041 -15.9392 +3700 4 14.4094 19.2869 39.3238 4.54227 2.45102 -23.4893 +3701 4 14.593 19.7098 40.7196 18.3341 34.8836 33.2243 +3702 6 14.5595 1.13832 10.2184 21.0915 11.237 11.4523 +3703 4 15.4791 1.15983 9.85648 -24.9846 -0.242798 0.374642 +3704 4 14.0639 0.416501 9.81608 3.47586 -8.24251 -5.69878 +3705 6 34.4238 40.9137 13.0059 -4.24882 -26.6665 -25.0696 +3706 4 34.0907 40.4301 12.2099 6.6876 25.2293 12.1693 +3707 4 34.3655 40.2093 13.6737 -1.45879 20.9599 -0.365544 +3708 6 42.1372 25.6317 33.9946 32.9644 -29.1434 -4.32848 +3709 4 41.7256 25.3671 33.1599 -4.34041 1.82357 5.58197 +3710 4 42.8775 24.9612 34.1276 -26.6125 21.4128 -4.76888 +3711 6 29.2041 22.5904 40.0709 -12.2401 -3.24737 -11.2113 +3712 4 28.5312 23.0545 39.5673 2.40343 6.95864 -1.48823 +3713 4 29.0042 22.7646 40.9807 1.44808 0.219743 17.343 +3714 6 44.8039 18.6198 1.5029 3.83338 16.5679 14.3409 +3715 4 44.9659 19.0204 2.39019 -3.90529 -17.866 -14.3425 +3716 4 44.0478 19.1074 1.16429 2.25905 3.06151 -3.31671 +3717 6 4.48486 10.8191 23.9456 -47.6019 -35.9978 3.19751 +3718 4 5.13394 11.3869 23.6113 33.8353 31.137 -11.4748 +3719 4 4.52769 10.7271 24.8961 2.68899 9.9192 5.78369 +3720 6 6.46393 23.0191 29.0034 23.802 4.69353 23.6764 +3721 4 7.14249 23.0161 29.7285 -18.6834 17.7038 -21.9419 +3722 4 6.49076 22.0968 28.8008 -10.0115 -22.5628 -12.4771 +3723 6 39.7912 25.1434 32.5739 17.5205 -18.6836 -60.5647 +3724 4 39.6128 25.3468 33.4485 -16.6712 22.7672 53.7369 +3725 4 39.6667 25.9357 32.0325 -1.3786 -0.359445 4.68486 +3726 6 40.844 21.4875 8.87812 10.6958 -1.16061 -24.4784 +3727 4 40.753 21.3778 7.91779 -6.86728 3.07162 8.13114 +3728 4 41.3272 20.6946 9.13123 4.7165 -6.17308 11.2164 +3729 6 0.614957 1.42802 12.9561 35.282 30.4207 -35.1483 +3730 4 54.8795 1.90166 12.5287 -4.84596 -15.7095 11.3484 +3731 4 0.325279 0.716474 13.4972 -22.2917 -16.9379 18.816 +3732 6 32.6687 29.7155 23.4821 0.172893 -14.8348 21.3896 +3733 4 32.2937 28.8037 23.5347 8.27316 18.2339 -7.75927 +3734 4 32.5776 29.9928 22.5742 -5.86304 -0.191283 -15.879 +3735 6 12.5314 37.1515 20.4729 45.6241 64.5302 32.6184 +3736 4 13.0675 37.1561 21.3077 -14.1528 -0.638655 -18.1117 +3737 4 12.0966 36.3476 20.454 -27.4762 -63.6198 -6.10217 +3738 6 13.8924 14.5151 24.69 -3.15938 -4.02598 20.115 +3739 4 13.491 15.2498 24.2338 -4.44789 9.69439 -9.34194 +3740 4 14.0279 14.8194 25.6039 -0.281954 0.872924 -9.09093 +3741 6 17.5021 27.063 26.4741 18.9499 -7.93165 -17.7551 +3742 4 17.3645 27.9616 26.0981 5.20292 -20.1733 2.46217 +3743 4 18.105 26.551 25.8503 -19.0729 23.9469 15.4793 +3744 6 54.4877 9.53021 26.3477 -5.78247 7.96784 25.4661 +3745 4 54.0512 10.3733 26.628 8.34027 -15.1138 -9.49744 +3746 4 54.8923 9.139 27.1544 -8.60221 9.32804 -13.3813 +3747 6 33.6807 21.5011 24.9225 20.8165 12.7411 -37.5161 +3748 4 33.6447 21.5342 23.9109 -0.857654 -11.0597 35.2787 +3749 4 32.8481 21.1477 25.2212 -19.5227 -6.82771 5.56304 +3750 6 22.1475 35.2701 2.885 -1.57378 -2.18642 30.1771 +3751 4 22.1887 34.3602 2.5781 3.09514 -3.18559 -9.19859 +3752 4 22.1072 35.1817 3.87164 0.12039 0.813186 -18.6146 +3753 6 45.3027 5.41438 15.6133 24.4211 -32.124 17.7203 +3754 4 45.2073 5.06649 16.5292 -4.89018 16.6426 -14.7318 +3755 4 44.541 5.92364 15.3615 -17.3903 4.72304 -1.03383 +3756 6 5.67534 7.5869 16.981 -5.47297 6.8358 -20.2139 +3757 4 5.25896 7.81046 16.1225 6.35918 -0.232773 12.9215 +3758 4 6.51331 8.07041 16.9918 4.7107 -6.94883 2.60141 +3759 6 34.576 39.0992 27.2053 24.5889 13.5844 -33.9491 +3760 4 34.3093 38.4547 27.8221 -16.0328 -19.2876 29.327 +3761 4 34.0621 39.904 27.3046 -7.96056 4.01318 13.6593 +3762 6 32.7541 33.6107 34.2903 -12.2088 11.6467 -22.6039 +3763 4 32.1008 34.0277 33.6489 27.9813 -13.6615 23.3944 +3764 4 32.6574 34.0489 35.1447 -11.8345 -0.637226 -0.957772 +3765 6 31.0088 41.2052 32.3952 -16.5884 -4.13679 -5.08533 +3766 4 30.2065 41.1942 32.9317 -1.71273 -1.00977 6.80252 +3767 4 30.9738 0.147898 31.9828 5.47722 15.337 -6.15299 +3768 6 7.65161 1.58314 27.1492 34.9115 -9.04616 -23.8477 +3769 4 8.49581 1.43905 26.61 -35.9655 -7.00487 18.1392 +3770 4 7.51162 2.51613 27.0476 -4.48076 16.5289 1.77021 +3771 6 0.884173 22.0999 37.8474 19.5684 -22.3581 -15.9684 +3772 4 1.29289 21.3236 37.3582 -15.3878 24.821 16.8607 +3773 4 1.19208 22.8872 37.3739 -1.97361 -3.14502 -0.467946 +3774 6 7.41204 11.1157 19.2314 -38.1481 -15.0427 -1.85178 +3775 4 7.53858 12.0593 19.2468 12.5581 17.6457 8.19935 +3776 4 8.2604 10.6916 19.3015 17.9889 5.14781 -4.65775 +3777 6 43.7858 12.4956 37.3097 0.920036 9.73958 -3.1733 +3778 4 43.9612 12.5094 36.3537 -0.436236 -2.21513 6.60981 +3779 4 44.6264 12.7918 37.692 -0.443403 -7.75914 -0.361508 +3780 6 29.0868 33.5248 36.1867 6.33086 18.8505 -43.8567 +3781 4 29.87 33.99 35.8176 -18.9328 -5.41066 10.4629 +3782 4 29.4633 33.0358 36.8874 15.3521 -14.5291 31.9885 +3783 6 14.802 4.59099 3.93345 20.4849 22.8827 12.2406 +3784 4 14.3757 4.0439 3.27797 -5.14737 -6.71868 -8.73832 +3785 4 15.6594 4.91612 3.57855 -16.4986 -14.1515 -5.85747 +3786 6 39.0551 6.39795 6.38864 -31.6963 1.09254 42.8867 +3787 4 39.3692 7.21691 6.04781 17.6944 18.3081 -17.2196 +3788 4 39.3538 5.69048 5.84285 10.6785 -8.50098 -20.4551 +3789 6 22.2123 37.9977 40.776 -14.7699 -23.2033 -28.4168 +3790 4 22.4586 38.8695 40.5021 9.68098 25.7962 -2.3277 +3791 4 22.4791 37.9118 41.6765 7.85923 -2.07179 26.9545 +3792 6 4.44877 23.2867 6.14309 -1.92846 -21.7963 14.7751 +3793 4 3.85981 23.8785 6.59389 -8.34079 22.3777 -5.30491 +3794 4 4.15148 22.4458 6.53602 18.5324 -1.87236 -10.5169 +3795 6 12.4298 23.7885 9.24819 15.5635 1.24594 19.7483 +3796 4 11.6299 23.5219 8.81427 -22.2296 0.449899 -3.14002 +3797 4 12.2156 24.1823 10.1208 2.55292 -1.37139 -18.7826 +3798 6 46.4922 15.2589 16.9667 3.22745 3.94864 2.0367 +3799 4 47.1791 14.9867 16.3488 -1.59454 -10.7105 -10.6804 +3800 4 46.8221 16.1143 17.2497 1.89409 2.98219 12.0057 +3801 6 34.1117 27.1644 19.7797 24.4736 -11.2812 21.2279 +3802 4 34.8774 26.5238 19.7962 -19.6491 14.1094 -6.20677 +3803 4 34.0324 27.4806 20.6991 -2.21978 -4.312 -16.0235 +3804 6 46.9479 13.2121 35.1109 14.7829 18.0264 15.8687 +3805 4 47.3232 14.0654 34.8894 8.1348 3.75559 6.81177 +3806 4 46.5576 12.9943 34.2929 -17.7211 -19.0679 -23.646 +3807 6 50.5883 18.7922 12.536 -4.97475 -8.40096 -18.6689 +3808 4 49.7377 18.4417 12.2063 9.85466 0.19572 8.20723 +3809 4 51.2037 18.6585 11.7837 -7.44169 10.1395 9.07394 +3810 6 32.4871 12.6357 31.9554 3.75694 -28.5712 -45.9238 +3811 4 32.607 11.6542 31.8864 5.47128 21.8321 9.55763 +3812 4 32.4011 12.8494 32.8587 -4.02679 2.16968 41.7104 +3813 6 6.20502 19.6778 10.0162 1.71901 21.9334 16.0314 +3814 4 6.41826 20.2441 9.25697 6.75258 -1.0862 1.44387 +3815 4 6.08129 20.3112 10.7738 2.93045 -16.0896 -19.0741 +3816 6 21.5254 21.5246 2.44441 10.1652 3.23891 -24.6245 +3817 4 21.7373 21.5014 1.49425 -3.90993 5.22039 4.49463 +3818 4 22.0841 20.8004 2.76184 -10.1442 1.98878 12.5692 +3819 6 38.3901 23.0895 17.1987 11.9637 -29.1373 -23.0023 +3820 4 38.7115 23.1739 16.2902 2.30233 23.4463 5.8212 +3821 4 38.6091 22.1461 17.2941 -10.4226 8.48715 23.8901 +3822 6 29.6992 24.9636 22.2212 38.6917 -37.4999 -9.7813 +3823 4 30.2244 25.0209 22.9989 19.9484 -5.9881 25.7874 +3824 4 29.0295 25.5321 22.4534 -63.588 46.0104 6.14599 +3825 6 30.2959 21.4331 37.7732 -36.6703 24.7369 -1.55525 +3826 4 30.3833 21.3736 36.7928 -5.6984 1.01251 23.2154 +3827 4 29.3642 21.7906 38.031 44.833 -25.8334 -23.6526 +3828 6 11.8968 11.712 16.3062 -52.2626 -16.509 -42.1992 +3829 4 11.3487 12.2512 16.8737 -4.04714 4.99791 6.8918 +3830 4 11.2749 11.5458 15.4981 35.5887 6.11969 38.645 +3831 6 5.69762 16.9728 10.4703 1.06122 -0.586779 5.28994 +3832 4 4.99177 17.1708 11.0979 -1.96678 -11.04 -5.71485 +3833 4 5.85288 17.8179 10.0528 3.40155 4.97172 -3.96907 +3834 6 41.7052 34.1635 35.8846 2.77529 22.9845 38.2917 +3835 4 41.9958 35.0267 36.2582 -8.6238 -19.1969 -5.00662 +3836 4 41.6615 34.3005 34.9574 -2.57818 -0.630621 -34.674 +3837 6 33.7668 1.16041 30.1021 -7.73366 -5.3538 60.0773 +3838 4 32.8437 1.27671 30.3431 -6.56672 10.3256 -18.6068 +3839 4 34.0939 1.04339 31.0463 15.1522 -1.22783 -40.312 +3840 6 50.3589 18.6227 36.9888 29.2523 22.0538 -2.88024 +3841 4 50.1022 18.8636 37.8788 -6.7252 3.81489 7.59342 +3842 4 49.7597 17.9698 36.6907 -30.5426 -29.286 -11.4073 +3843 6 24.6818 24.2557 40.239 -30.3362 18.6852 9.52233 +3844 4 23.7683 24.4347 40.5809 21.1328 -2.57181 -5.50386 +3845 4 24.791 23.3075 40.3447 2.5826 -1.14956 -5.51696 +3846 6 37.3025 22.0306 23.2304 -1.24857 -1.55203 26.5345 +3847 4 37.0034 21.8174 24.1364 -3.77965 7.42086 -11.5868 +3848 4 37.7677 21.2337 22.9852 8.84969 -1.31238 -13.2672 +3849 6 48.4163 40.4951 28.9695 -6.68628 11.813 -16.9736 +3850 4 49.0084 41.2243 28.7075 -10.6266 -4.31108 -6.63999 +3851 4 47.6767 40.479 28.3098 12.2088 -0.876211 11.6705 +3852 6 24.8524 8.74511 16.566 -5.47802 -1.24744 16.6444 +3853 4 25.3154 9.32041 17.1898 2.58295 -0.80606 -7.28092 +3854 4 25.3735 7.93816 16.4942 1.51819 -5.71343 -7.74972 +3855 6 19.2312 23.0154 32.4581 7.29767 -10.2486 -2.08042 +3856 4 18.4295 23.4489 32.1618 3.75321 4.57429 -6.83594 +3857 4 18.9208 22.4103 33.1253 1.01223 -4.21105 8.69504 +3858 6 3.33807 21.6805 22.4551 -46.3933 -7.60477 16.0737 +3859 4 2.65604 22.1286 23.0335 23.3212 -20.9163 -13.0515 +3860 4 4.02869 22.318 22.3903 27.1551 13.0827 -5.07429 +3861 6 10.2258 20.3371 12.829 -8.54969 -20.6717 -8.68144 +3862 4 9.56384 20.8338 13.3253 4.28314 2.73019 -3.94148 +3863 4 9.70568 19.6401 12.367 8.3544 15.6282 9.01344 +3864 6 9.53393 0.668964 25.3385 8.23748 17.1946 -9.08311 +3865 4 10.3992 0.538209 25.8183 -20.1327 16.9559 -17.4439 +3866 4 9.57635 1.38514 24.6117 12.9812 -33.3008 29.4344 +3867 6 10.6624 40.712 9.64369 -16.6479 -8.09828 -30.6343 +3868 4 10.6692 41.3905 10.303 1.51816 10.4523 18.0663 +3869 4 9.97599 41.0031 8.99599 12.0328 -9.66263 16.6565 +3870 6 46.359 25.2248 32.6769 -14.7838 37.2607 37.796 +3871 4 46.1367 26.0735 33.2154 13.6855 -48.6436 -31.9122 +3872 4 46.6282 25.5659 31.8216 4.36769 -3.83668 -6.22015 +3873 6 38.9431 3.2028 23.1016 18.0409 -17.6687 24.963 +3874 4 38.0396 3.32435 22.9005 -28.138 13.963 -19.732 +3875 4 38.8834 2.64883 23.9052 13.1186 5.8311 -6.82495 +3876 6 33.334 23.6417 36.8871 -1.6197 -14.346 14.9842 +3877 4 32.7695 23.6175 37.7211 18.6046 10.6207 -30.6843 +3878 4 33.5528 24.5621 36.6745 -4.59115 1.63353 1.59233 +3879 6 51.9355 33.3272 25.435 24.4931 61.1901 -39.0042 +3880 4 51.4286 33.1494 26.1943 -20.5556 -13.8295 37.3068 +3881 4 51.9313 34.3506 25.3627 -2.33157 -52.0679 -5.38276 +3882 6 32.1777 25.0215 33.1655 -4.40266 21.2191 -9.05445 +3883 4 32.7541 25.8194 33.0841 -10.7751 -17.7804 3.95932 +3884 4 31.2703 25.3891 33.0319 13.5135 -10.8842 0.697404 +3885 6 51.2858 27.7149 39.5023 -29.438 -28.7732 26.1015 +3886 4 51.6029 27.7352 38.6212 16.0201 9.86215 -30.6452 +3887 4 51.6337 28.456 39.976 12.6328 17.4546 7.30145 +3888 6 34.2938 28.319 17.2582 8.1769 -6.30709 4.0332 +3889 4 33.5147 28.7567 16.9609 -27.2201 13.5182 -7.119 +3890 4 34.2215 28.3851 18.2119 5.48963 -10.3892 10.8325 +3891 6 36.9125 8.03614 37.8626 31.6258 41.6511 37.5008 +3892 4 37.1772 8.64874 37.1722 -6.23292 -16.4311 -22.0997 +3893 4 37.3691 8.52088 38.6203 -30.9712 -36.3395 -15.9768 +3894 6 34.8794 19.4073 6.12479 12.5531 6.66298 1.29528 +3895 4 34.0931 18.8687 6.15723 -9.84615 -2.81902 0.903663 +3896 4 34.5874 20.3343 6.07707 7.75337 -1.04832 -3.72421 +3897 6 52.9388 9.46792 7.82791 49.0384 32.8563 -49.3294 +3898 4 52.8922 10.1625 7.06425 -6.6048 -31.3865 41.9454 +3899 4 52.145 9.34409 8.30569 -37.6802 7.72308 13.142 +3900 6 36.3078 5.4787 38.9756 -59.3492 -35.3574 -23.3076 +3901 4 36.7604 5.44249 39.7856 34.2456 7.44664 27.0781 +3902 4 36.4713 6.28646 38.5283 19.3627 32.146 -13.2298 +3903 6 10.0102 14.4476 13.47 7.45507 32.9986 11.9551 +3904 4 10.2267 15.3574 13.7991 -6.33005 -21.0964 -5.42394 +3905 4 9.26267 14.5991 12.8847 -7.70629 -5.78085 -0.713961 +3906 6 17.2158 24.3617 39.7859 1.82925 -26.4802 17.5225 +3907 4 16.9252 25.2477 39.6578 -10.2532 23.1813 -8.78866 +3908 4 16.8659 24.1409 40.6742 12.3143 -2.49802 -8.33055 +3909 6 49.0708 32.5605 7.76617 4.98775 -19.9892 12.4117 +3910 4 48.2488 33.0406 7.85919 -4.66971 4.38963 1.84033 +3911 4 49.5854 32.9586 7.08254 9.03816 10.9607 -18.1455 +3912 6 44.8772 24.3958 5.47001 55.4245 15.4507 -4.26518 +3913 4 44.8128 24.5742 6.41303 -16.1158 -0.171295 7.10823 +3914 4 44.0866 23.9971 5.17679 -42.0653 -18.1716 -4.3799 +3915 6 37.3106 29.1913 32.8596 13.2918 -7.82588 25.4298 +3916 4 36.7195 29.353 33.61 10.148 2.43022 -0.346483 +3917 4 36.7915 29.3572 32.1043 -27.5405 3.64351 -29.7293 +3918 6 0.903259 24.8209 21.2384 21.1637 23.8586 -12.5999 +3919 4 1.07153 25.1845 20.3306 -6.36458 -4.90686 24.2304 +3920 4 1.48599 25.3539 21.839 -15.2813 -16.355 -7.82064 +3921 6 53.0335 2.20305 13.0061 -8.76459 0.917863 -30.1717 +3922 4 52.7178 1.83592 13.8181 -1.16689 -4.66991 20.3458 +3923 4 53.3973 3.07458 13.1779 4.70755 1.41814 13.7418 +3924 6 24.3073 33.9788 13.9425 26.9643 -19.8352 3.53447 +3925 4 23.8166 33.1535 14.1304 2.48225 11.7572 -2.64876 +3926 4 25.2622 33.8278 14.204 -36.1259 9.29052 -3.07765 +3927 6 40.931 19.3008 0.314297 -22.2267 40.7784 4.53314 +3928 4 41.073 18.3876 0.266006 15.5735 -49.6404 -1.39225 +3929 4 41.7685 19.7545 0.415523 11.1161 2.19254 -0.550631 +3930 6 38.3131 32.0321 21.5909 -11.558 27.6654 -12.3629 +3931 4 37.7152 31.3901 21.181 3.54948 -0.803384 -4.61225 +3932 4 38.0485 32.9451 21.2634 6.02672 -33.9485 15.0266 +3933 6 42.3093 34.9988 16.9782 -31.0886 21.3467 -4.04435 +3934 4 41.4322 34.9872 17.4259 23.1708 5.16072 -1.2535 +3935 4 42.7209 34.172 17.1456 10.0707 -23.8474 2.85212 +3936 6 19.5555 24.3301 21.9337 4.81064 -45.312 41.7565 +3937 4 19.0503 23.5208 22.2695 18.6897 32.4519 -16.5084 +3938 4 18.9494 24.7901 21.383 -21.2783 9.24005 -16.3011 +3939 6 21.0765 3.08453 14.9497 18.8565 6.62045 0.482113 +3940 4 21.9827 3.42458 15.1377 -20.4059 -2.71097 -2.70114 +3941 4 21.0593 2.94323 13.9894 -7.00518 -5.35814 1.95693 +3942 6 16.4422 12.1477 28.531 -0.750899 4.00912 3.87665 +3943 4 16.9503 12.6102 29.2147 -1.62139 -0.392447 -5.94721 +3944 4 15.8278 12.7952 28.1633 1.40376 -4.03425 1.22377 +3945 6 29.5501 4.7113 21.752 31.6763 -19.7408 -11.7502 +3946 4 29.7575 3.81476 21.3864 -8.62397 20.1371 9.94028 +3947 4 28.6767 4.97136 21.4837 -14.307 1.15287 -5.34284 +3948 6 47.4015 12.0887 13.4082 -20.234 -20.0739 19.2385 +3949 4 46.7896 12.1748 12.658 5.24956 2.33261 8.08179 +3950 4 46.8763 11.6307 14.143 25.8489 23.9178 -32.3489 +3951 6 26.4368 0.034911 5.58657 -64.7941 -10.5287 17.818 +3952 4 25.4579 0.386547 5.64311 57.7785 -5.53424 -8.5606 +3953 4 26.2825 41.0177 5.90114 11.1228 18.2746 -10.9356 +3954 6 20.8239 34.8091 41.3451 3.02448 22.7042 23.7072 +3955 4 20.8848 35.7307 41.7064 -1.83719 -23.2001 -12.5561 +3956 4 21.5135 34.3024 41.8142 -0.435548 5.34794 -5.15218 +3957 6 12.6914 17.4806 1.38079 -1.22179 11.8948 19.0955 +3958 4 12.6924 17.2614 2.32235 1.20892 0.120609 -3.36771 +3959 4 12.6119 16.652 0.923905 -0.609755 -13.5185 -16.0456 +3960 6 30.0783 10.198 8.41195 2.12134 -1.25171 -25.3141 +3961 4 29.3533 10.7626 8.0964 5.01977 -3.23694 0.534487 +3962 4 29.9182 10.0601 9.33268 -3.94599 -2.47727 24.1034 +3963 6 36.3506 5.44781 23.9083 -0.549638 14.3818 20.7021 +3964 4 36.0156 6.32048 23.6328 6.62881 -2.58855 0.476976 +3965 4 37.0027 5.63115 24.6267 -8.58297 -8.41851 -13.9364 +3966 6 34.0301 39.9488 19.4964 -23.0399 -20.8249 18.5921 +3967 4 34.456 39.4415 20.2152 6.93565 15.6495 -14.2212 +3968 4 34.6348 40.5483 19.0534 11.5364 2.12704 2.14354 +3969 6 25.0981 29.0133 17.0022 63.4673 53.603 -24.6749 +3970 4 24.4066 28.4545 17.2066 -49.3728 -47.1307 14.2315 +3971 4 24.9323 29.3693 16.11 -4.01222 -10.2038 10.3173 +3972 6 28.4991 21.3215 6.5284 30.3134 51.3135 12.4116 +3973 4 28.073 21.8131 5.82363 -12.0684 -17.0718 -17.6117 +3974 4 29.0439 22.0969 6.88435 -18.1485 -38.7813 5.23359 +3975 6 18.6639 26.1486 0.434559 17.278 41.4043 -10.2832 +3976 4 18.2934 25.3073 0.618971 -26.4426 -25.2614 5.85754 +3977 4 18.1648 26.8598 0.892557 2.28699 -17.4047 3.2853 +3978 6 10.9881 29.7025 15.4563 -76.0882 18.6105 19.9394 +3979 4 11.66 29.3744 14.945 58.6215 -25.2203 -34.7363 +3980 4 11.3165 30.0451 16.2682 18.0847 5.23212 20.5617 +3981 6 33.4842 3.75768 10.5858 0.636803 10.5574 28.6939 +3982 4 33.4734 3.50079 11.5612 -0.522502 1.02567 -36.066 +3983 4 33.5593 4.73652 10.6 -0.068286 -14.4363 0.33475 +3984 6 12.2823 28.8038 23.0281 11.3775 -6.29424 6.84391 +3985 4 12.7596 29.6284 22.9364 3.04418 8.52871 -1.54448 +3986 4 11.6562 28.9633 23.7417 -11.9653 1.92572 -6.97409 +3987 6 13.0879 10.2853 41.0171 -47.2786 6.02767 7.69694 +3988 4 13.8008 10.0588 41.5617 38.8858 -12.6991 24.323 +3989 4 13.445 10.533 40.1929 12.5253 9.31307 -31.237 +3990 6 45.8279 29.9763 22.3517 -19.0059 -47.3471 -0.794771 +3991 4 46.3385 30.6632 22.7121 22.9496 35.5749 11.5915 +3992 4 46.1736 29.1608 22.8005 -10.4716 15.4455 -15.9284 +3993 6 41.5587 12.1258 14.79 16.8952 2.46742 -19.497 +3994 4 40.8127 12.0778 15.3866 -8.88903 2.06539 11.4921 +3995 4 41.9001 13.025 14.8368 0.886253 5.83282 4.44761 +3996 6 18.1774 7.21532 24.17 -10.7079 71.0597 15.5191 +3997 4 17.3895 7.85304 24.2309 32.278 -29.8877 -8.26822 +3998 4 17.8432 6.3671 24.0218 -31.5603 -50.1252 -1.23769 +3999 6 1.46617 28.3087 7.5822 17.4051 32.8243 -18.4272 +4000 4 0.972435 27.5241 7.77639 -23.983 -7.56132 -3.64975 +4001 4 0.919057 29.0368 7.16413 8.17263 -22.6878 11.3207 +4002 6 11.3257 12.3178 24.0505 6.50608 36.5044 21.7543 +4003 4 11.787 12.9182 24.6663 -15.142 9.53056 -9.69028 +4004 4 11.7144 11.5384 24.3755 9.90684 -45.3393 2.97811 +4005 6 17.9727 40.4585 24.4268 -2.1753 13.4943 43.6914 +4006 4 18.2079 40.9973 23.706 15.3173 17.1897 -35.5256 +4007 4 17.8423 41.1404 25.131 2.16294 -27.9915 -10.5346 +4008 6 25.5983 7.44259 34.0136 19.3716 5.77393 -21.6373 +4009 4 25.8935 7.97324 33.2232 -7.88236 -13.8451 20.6491 +4010 4 24.6626 7.5793 34.1612 -12.3217 5.75259 0.6842 +4011 6 16.9533 36.3934 7.79695 -14.7733 -58.972 -15.2131 +4012 4 16.1509 35.7821 7.92089 32.5681 38.8119 0.0631702 +4013 4 16.873 37.2333 8.21975 -10.866 19.0251 14.3825 +4014 6 12.4478 39.1676 36.8063 -58.2746 -19.2691 -7.14825 +4015 4 13.2621 39.5728 37.0444 24.763 -2.90148 -1.94315 +4016 4 12.5678 38.2718 36.42 14.2903 21.5885 11.3364 +4017 6 23.4428 1.91286 37.7232 -9.22102 6.32267 -24.8838 +4018 4 22.7837 1.60923 37.0782 3.11058 2.78987 13.6287 +4019 4 23.6923 2.7833 37.361 6.97145 -2.92816 9.87668 +4020 6 26.6131 34.8527 39.0629 -0.358317 22.46 -5.08852 +4021 4 25.9211 35.0251 39.7209 4.63868 -0.642547 -8.45736 +4022 4 26.6245 35.623 38.4346 -11.8568 -25.3624 13.8384 +4023 6 44.7506 35.5772 23.1679 10.7298 -18.8811 -26.4233 +4024 4 44.6498 36.2622 23.8111 -7.39072 22.4611 10.5052 +4025 4 44.899 35.9413 22.2637 -2.27133 -5.1907 16.9936 +4026 6 34.6136 35.4178 26.71 -15.9342 1.46423 13.2724 +4027 4 33.7739 35.201 27.1682 15.3038 9.13482 -13.5788 +4028 4 35.2424 35.4667 27.4557 -1.55634 5.60609 -12.3698 +4029 6 12.4253 29.8367 9.37257 6.8074 7.71813 14.8361 +4030 4 12.5954 30.1793 10.279 -1.64518 -2.79843 -17.3301 +4031 4 11.9756 30.5342 8.87466 -2.55144 0.413422 5.70549 +4032 6 46.4578 41.3781 16.9525 -1.71223 -15.9012 -6.63524 +4033 4 46.309 0.164546 17.5847 2.66821 13.6546 8.2853 +4034 4 46.3887 41.8168 16.0911 -0.805017 -2.71613 2.08401 +4035 6 39.1753 31.0467 24.0118 -3.10819 6.08124 -21.6124 +4036 4 39.1065 31.2708 23.0301 -7.23524 -5.82233 36.9271 +4037 4 38.2867 31.0608 24.4123 9.52041 3.88051 -10.8568 +4038 6 40.5402 9.7597 28.9847 14.8037 -28.2595 -25.194 +4039 4 40.7176 8.78836 28.9335 -4.00485 22.4893 3.39032 +4040 4 39.9733 9.89103 29.7293 -9.65138 5.58475 19.0645 +4041 6 33.5593 11.9211 22.729 -1.15717 -3.69298 36.7387 +4042 4 33.4631 12.1387 21.8005 -14.8881 8.7456 -3.74916 +4043 4 32.9393 12.4796 23.2922 26.8098 -15.4098 -27.756 +4044 6 29.0159 38.7519 2.46278 27.6721 -15.5988 -40.3681 +4045 4 29.1586 39.6546 2.1748 2.74048 3.67355 2.54153 +4046 4 28.5501 38.8453 3.26351 -22.211 -0.421087 25.3577 +4047 6 51.2833 6.14739 28.3043 6.24107 -1.78447 -16.8419 +4048 4 51.6927 5.30788 28.0231 -4.79213 3.01935 13.8596 +4049 4 51.5671 6.73798 27.5888 -1.89698 -2.53529 10.4249 +4050 6 34.1064 16.6123 14.042 -37.0155 -16.4066 -7.07731 +4051 4 33.9904 17.5439 13.9588 -10.6946 23.5239 -0.125603 +4052 4 35.0244 16.4872 14.0391 48.662 -2.86898 -0.118382 +4053 6 34.4321 40.0645 7.48859 13.9518 5.57425 38.6209 +4054 4 34.6497 40.8416 6.93548 -15.3832 -25.9537 -5.407 +4055 4 34.0868 39.3056 7.01264 2.49953 7.17747 -18.8692 +4056 6 42.5297 22.9808 4.38266 2.56422 12.7755 -29.8183 +4057 4 42.7079 23.1404 3.43503 2.07895 -8.20356 9.72626 +4058 4 41.6007 23.2438 4.43282 3.68115 -1.88729 13.9368 +4059 6 1.41725 11.7089 10.583 40.9585 72.4956 7.82458 +4060 4 2.29602 11.7947 10.1149 -31.3121 -19.1762 2.07637 +4061 4 1.32217 12.6809 10.8959 0.250133 -47.8987 -12.0904 +4062 6 10.0222 17.1523 40.4009 -13.9984 -42.4532 23.0969 +4063 4 9.09922 16.7881 40.4362 25.3227 17.9847 -3.64852 +4064 4 10.5566 16.4623 40.9043 -11.7978 28.1532 -20.1855 +4065 6 26.3773 1.16785 23.7951 0.897687 17.1036 -20.4546 +4066 4 26.2949 1.59753 22.8926 6.72339 -10.2637 31.134 +4067 4 26.8106 1.83522 24.3632 0.404944 -5.36666 -8.232 +4068 6 4.47728 16.2319 39.0174 38.9165 -19.7518 -18.3291 +4069 4 4.60126 15.8787 38.0926 -3.95383 11.2541 23.7603 +4070 4 5.37849 16.1152 39.4714 -36.6531 9.54225 -13.0705 +4071 6 24.3645 39.8454 14.0862 11.6717 18.512 -7.42816 +4072 4 24.2179 40.7168 13.6655 -1.51261 -13.0973 5.973 +4073 4 25.144 39.5095 13.6466 2.38152 -7.3908 -1.6645 +4074 6 19.9724 19.004 10.1294 8.87966 -14.5095 2.71373 +4075 4 19.0999 19.3915 10.2782 -1.93643 -3.06257 7.63815 +4076 4 20.1403 18.2899 10.8137 -9.49435 28.7308 -18.8504 +4077 6 45.2455 15.0555 25.2985 9.44949 25.5865 29.6023 +4078 4 44.5225 15.6147 25.6238 -9.11717 -2.3226 -13.4673 +4079 4 44.9162 14.4027 24.6993 -17.0358 -18.2103 -14.0354 +4080 6 47.6513 32.9537 29.9733 -3.02769 -8.48031 15.1317 +4081 4 47.7848 32.4488 30.7976 5.01558 10.2706 -8.76515 +4082 4 46.6987 33.0693 29.9097 -5.02316 -0.316015 -4.02449 +4083 6 9.31033 14.1561 35.6305 -9.15199 13.4931 14.7277 +4084 4 10.2186 13.9515 35.3646 1.69372 -1.68405 10.862 +4085 4 9.25805 14.5533 36.5394 11.2175 -11.577 -22.5615 +4086 6 0.560208 28.7354 32.128 -23.2584 38.0618 20.8665 +4087 4 0.439761 29.1616 31.2639 2.79308 -8.58991 0.800302 +4088 4 0.67028 27.8063 31.9961 10.5465 -16.7679 -9.91325 +4089 6 26.1282 14.1993 40.8411 59.6454 -38.6249 5.43898 +4090 4 26.432 13.4524 41.4491 -20.3805 31.5142 -12.0858 +4091 4 25.201 14.2926 40.8644 -35.6636 2.31432 7.08225 +4092 6 38.0409 1.72795 37.3461 -15.986 9.3487 3.27435 +4093 4 38.337 1.77003 36.4219 -6.4212 0.733726 8.60438 +4094 4 37.1869 2.24333 37.3721 25.3175 -16.9011 -0.126137 +4095 6 43.391 21.0055 0.385428 11.1435 51.3868 10.1231 +4096 4 43.3728 21.9356 0.739051 -22.7765 -27.5137 5.23027 +4097 4 44.2566 21.1078 41.893 4.66373 -25.0138 -11.6612 +4098 6 29.7339 12.3948 17.084 15.7249 11.0657 13.1734 +4099 4 30.3928 12.9555 17.5239 -4.04604 16.1495 -27.1654 +4100 4 29.6387 11.801 17.8166 -19.321 -23.8097 4.84602 +4101 6 21.0831 10.9976 35.6454 20.8751 25.9078 26.8503 +4102 4 20.9144 11.9356 35.5 -2.5465 -0.914036 2.40284 +4103 4 20.6111 10.5739 34.9651 -17.7649 -25.2648 -31.6786 +4104 6 24.3635 22.1336 17.0651 -49.7832 5.03398 -16.9936 +4105 4 24.7447 22.8357 16.5516 14.0354 11.6369 -2.31656 +4106 4 25.0369 21.6158 17.4366 35.7007 -17.2122 18.4164 +4107 6 44.2543 9.63808 6.15039 20.313 -11.2139 14.5913 +4108 4 44.7688 9.46356 5.36091 -1.47318 -0.699349 -10.0319 +4109 4 43.371 9.9028 5.92157 -14.9065 6.10764 -5.2575 +4110 6 40.8032 2.87739 6.28666 -13.1289 22.479 10.901 +4111 4 40.3272 3.11809 7.09229 2.74106 -9.45257 -1.64817 +4112 4 40.5645 3.60702 5.69531 8.12536 -6.41414 -12.3146 +4113 6 23.4888 29.7691 25.1996 -20.8577 -7.3866 7.78845 +4114 4 23.0356 30.0691 24.4173 -11.1707 -5.96106 -7.76576 +4115 4 24.1981 30.3761 25.2406 38.2449 14.7306 0.541559 +4116 6 45.2336 20.6129 7.48752 -14.5833 -17.9538 -3.88696 +4117 4 44.4222 20.5961 6.94177 10.1673 3.83834 -0.615812 +4118 4 45.4226 19.6724 7.65027 4.1577 11.2609 0.378107 +4119 6 44.1804 26.5848 16.646 -7.77871 8.0927 60.0057 +4120 4 44.4497 26.5291 15.7549 9.82788 -17.3929 -39.3829 +4121 4 43.995 25.6977 17.0036 0.668911 -2.30329 -14.751 +4122 6 23.5902 27.0659 18.0913 -39.7013 -11.93 7.95298 +4123 4 23.083 26.2674 17.8176 19.208 11.4009 -9.44785 +4124 4 22.9184 27.4761 18.6801 25.6051 0.00742342 -8.40738 +4125 6 45.1467 16.0991 8.91755 -25.3782 -1.90264 -8.59791 +4126 4 44.1891 15.9425 8.7462 16.1978 6.4454 1.17339 +4127 4 45.2138 16.0078 9.87006 7.52298 -2.6657 10.2407 +4128 6 39.0203 15.1531 5.23259 28.6956 12.0263 -26.8074 +4129 4 39.7994 15.5772 4.7964 -10.087 -12.1112 6.39319 +4130 4 38.3368 15.7917 5.08662 -19.5574 10.6606 0.980846 +4131 6 40.468 4.77411 20.0927 -27.3359 -4.798 12.1592 +4132 4 41.2634 4.72652 19.6 29.6653 -1.38796 -18.2664 +4133 4 40.7147 5.23292 20.8909 -0.487482 4.30709 11.6637 +4134 6 35.8395 28.4372 39.9091 -50.8572 -25.335 -8.14583 +4135 4 35.0416 27.8127 39.7761 37.8149 25.8469 12.2999 +4136 4 36.4241 28.1912 39.1903 12.774 -11.5781 0.139918 +4137 6 26.5706 3.57143 2.67715 -46.9093 11.529 -12.2012 +4138 4 26.01 3.47498 1.86726 21.0232 -0.263485 19.1529 +4139 4 25.9795 4.13239 3.25499 25.5536 -16.3527 -3.3314 +4140 6 2.96374 21.6426 17.6806 -14.2306 -5.51577 -4.68338 +4141 4 2.93927 22.2072 18.4518 0.989431 6.72084 9.51867 +4142 4 3.70489 21.9005 17.1296 5.59779 10.8847 0.849605 +4143 6 12.8869 25.0552 25.9401 15.4127 26.4598 -14.83 +4144 4 13.2774 25.9118 25.6194 -5.06291 -21.1213 8.866 +4145 4 12.0842 24.9634 25.4247 -11.7493 -3.09829 -2.0396 +4146 6 41.5869 20.6707 14.1801 -22.4147 -6.05744 0.611169 +4147 4 42.2929 20.1295 13.8255 12.8925 2.43785 -7.39699 +4148 4 41.9118 21.5622 14.3536 8.70683 -8.7017 2.36606 +4149 6 1.26372 39.5934 11.5416 -2.31472 -23.2994 -17.666 +4150 4 1.60499 38.7626 11.0579 -12.721 36.8399 30.164 +4151 4 1.30151 39.4907 12.5143 8.15813 -4.07121 -11.1907 +4152 6 16.0274 39.0089 34.0759 -23.376 3.35378 -54.2756 +4153 4 15.5279 38.2654 33.6809 12.2329 5.59336 21.1278 +4154 4 15.9645 39.6681 33.3256 8.94624 -4.65522 31.8649 +4155 6 20.5749 7.01511 25.5545 -9.93748 22.9073 -1.77669 +4156 4 20.7998 7.9126 25.2373 7.69672 -13.5438 0.480138 +4157 4 19.6147 7.02086 25.4453 1.79337 -5.45304 -5.32881 +4158 6 45.1903 25.5946 39.1745 -26.3826 2.10768 23.1727 +4159 4 45.9078 26.0337 38.7511 23.0136 15.7961 -19.2282 +4160 4 45.315 24.6755 38.9972 4.74877 -22.0383 -3.82349 +4161 6 19.9254 40.1108 28.2935 0.936604 13.13 -6.83142 +4162 4 19.0415 40.3022 27.9603 -1.00367 -13.9734 -0.221352 +4163 4 20.1058 40.9072 28.8104 6.81084 -8.28794 7.10232 +4164 6 26.5025 14.2024 27.3816 7.55525 -11.5245 -39.7478 +4165 4 25.5661 14.1885 27.2241 -23.3405 -0.187867 -1.3667 +4166 4 26.5864 14.6167 28.2174 4.05242 7.69107 36.9512 +4167 6 51.349 25.9455 3.44193 13.1564 1.83251 -14.1309 +4168 4 51.0731 25.276 4.04973 -8.84751 -13.2679 15.0063 +4169 4 51.8098 25.4164 2.75525 -2.9574 19.5765 2.79729 +4170 6 20.1579 26.1269 2.66057 8.08543 -14.232 12.5138 +4171 4 20.4198 25.2285 2.95049 1.99012 13.1431 -7.88687 +4172 4 19.9848 26.1042 1.70984 -1.68704 0.137755 2.48294 +4173 6 3.12857 11.9594 27.2244 18.8731 20.7243 14.7894 +4174 4 2.60719 12.6622 26.8077 5.30838 -2.59233 -3.81502 +4175 4 3.76928 12.4285 27.8301 -19.9135 -11.7573 -12.7739 +4176 6 30.1745 26.3671 4.00755 44.117 -33.7612 35.926 +4177 4 30.7719 25.91 3.40695 8.20711 -11.5121 5.52432 +4178 4 29.6741 26.8182 3.4039 -49.0538 48.0497 -39.0484 +4179 6 19.309 20.6617 30.5327 -6.17305 20.3286 19.7257 +4180 4 19.3357 21.5037 31.0044 -16.2324 -1.53368 2.5841 +4181 4 20.215 20.6027 30.2783 24.1248 -10.9268 -16.9107 +4182 6 13.5428 36.2605 0.333332 15.0011 -10.6689 28.2547 +4183 4 13.9636 37.1467 0.274336 -13.564 -9.3403 -16.0521 +4184 4 12.8146 36.0991 41.6409 -4.77188 14.7057 -15.3617 +4185 6 13.69 21.7667 35.9665 -20.2473 -15.4187 -13.4538 +4186 4 13.4364 21.3658 35.099 7.7487 10.4825 13.8843 +4187 4 14.5406 22.1631 35.8296 17.4857 6.37333 -3.13554 +4188 6 39.4374 1.76506 25.3393 -36.4427 -7.29022 -10.5984 +4189 4 39.9364 2.34528 25.9215 16.7605 -3.08023 1.72977 +4190 4 39.8192 0.8892 25.1573 19.013 15.1682 11.727 +4191 6 18.3049 6.14326 35.8392 -10.8025 -19.5812 3.54688 +4192 4 18.125 5.32611 36.3393 4.50778 0.182671 -16.8727 +4193 4 18.2664 6.78418 36.55 10.3297 13.4079 -7.40032 +4194 6 2.50698 24.635 10.1008 2.82606 57.1639 14.1456 +4195 4 3.34783 24.2504 10.0645 38.9609 -42.7111 -6.9151 +4196 4 2.85647 25.509 10.4424 -34.1939 -15.4438 -5.60802 +4197 6 35.8245 9.94707 1.36321 12.392 22.5458 6.51215 +4198 4 36.2598 10.3662 0.602857 -1.03193 -1.33218 7.37913 +4199 4 36.14 10.4815 2.15194 -8.91958 -29.9524 -28.0328 +4200 6 29.0093 17.9332 41.5934 -7.9582 -11.0366 0.585828 +4201 4 28.5465 17.2289 41.1281 -16.7755 -3.81322 9.83818 +4202 4 29.6221 18.1453 40.9114 24.9254 25.1746 -10.164 +4203 6 46.0106 27.0842 25.8657 -15.8538 -10.6571 1.20957 +4204 4 46.7573 26.8966 26.4316 13.3887 1.52966 8.34957 +4205 4 45.3967 26.3449 26.0537 1.02353 6.85943 -7.5889 +4206 6 28.1115 10.6516 35.9124 -31.4415 -9.81676 -35.067 +4207 4 27.3321 11.0804 35.4953 10.9044 -14.8673 0.927998 +4208 4 28.4149 11.3158 36.4913 19.5717 24.3857 28.0975 +4209 6 25.9462 20.1874 24.7713 21.0981 19.7274 8.06252 +4210 4 26.7479 20.7296 24.6265 -12.3387 -9.71047 -3.27099 +4211 4 25.8934 20.1715 25.7373 -11.4252 -1.9185 3.65337 +4212 6 32.2315 30.2636 10.2038 46.2181 -42.2335 3.06511 +4213 4 32.6954 30.7903 9.55855 -13.4496 21.2522 -10.6663 +4214 4 32.9512 29.5744 10.3289 -28.7668 14.232 9.31608 +4215 6 5.05112 34.4033 23.8133 19.5013 -14.7597 17.0713 +4216 4 5.8904 34.9145 23.8209 -18.4686 -4.57798 -7.44977 +4217 4 4.4328 34.8283 23.2333 -4.78059 12.4432 -11.9709 +4218 6 29.6287 34.9421 23.1129 15.2461 20.4143 1.29823 +4219 4 30.2662 35.203 23.7945 -9.70178 1.77141 2.28452 +4220 4 29.7307 34.0083 23.0447 -4.13429 -24.1479 2.03513 +4221 6 52.1909 25.2296 36.2512 2.86438 -10.6824 22.6831 +4222 4 51.9483 25.3775 37.2028 5.23419 -4.07811 -26.4725 +4223 4 52.3343 24.2634 36.1804 -4.32722 6.81431 1.64545 +4224 6 6.96184 41.26 14.9825 2.80521 -5.8094 -40.534 +4225 4 7.04984 41.0874 15.8994 5.94782 -9.0625 22.8431 +4226 4 7.58542 40.6644 14.4953 -8.6815 16.2518 18.3581 +4227 6 27.6618 39.1341 4.65497 -15.321 -2.42325 19.5764 +4228 4 26.8583 38.6531 4.9607 13.8024 7.31782 -7.34321 +4229 4 28.2878 39.16 5.39008 -5.06496 -7.53921 2.22048 +4230 6 44.4448 15.8874 30.3939 -2.31018 0.103575 -22.4191 +4231 4 43.6353 16.4379 30.2788 15.6665 -12.4266 1.42045 +4232 4 44.7559 15.574 29.5018 -16.8402 11.4423 19.721 +4233 6 27.2939 38.1254 13.0955 15.3768 -40.6351 2.35664 +4234 4 27.6299 37.3572 12.5713 -6.06373 15.2601 5.99839 +4235 4 27.2975 37.7701 14.0147 -10.0522 11.5876 -10.9657 +4236 6 26.6773 32.9794 36.8294 -32.6396 -25.4624 12.1292 +4237 4 27.3491 33.5429 36.5103 30.2383 22.5556 -9.12925 +4238 4 26.1784 33.4868 37.4729 2.39424 7.35453 7.52648 +4239 6 26.3034 28.2003 31.7109 71.1077 16.3155 0.283388 +4240 4 26.8193 28.3341 30.863 -27.929 -6.55919 23.3278 +4241 4 26.9955 28.4613 32.4053 -35.143 -9.24619 -18.2719 +4242 6 49.2075 35.7729 23.3324 -21.4287 30.6035 9.89313 +4243 4 49.7648 36.3085 23.9054 5.92838 -6.84736 -0.0129328 +4244 4 49.7125 35.0813 22.9401 23.5965 -22.3057 -11.2126 +4245 6 44.2384 15.3735 33.5479 -0.546939 -12.4927 -0.897907 +4246 4 44.8734 15.133 32.8785 13.8917 -2.34347 -2.72297 +4247 4 43.5631 15.8174 33.0372 -7.79828 14.1806 -0.143619 +4248 6 16.6415 35.2629 14.0425 -13.711 -12.7272 -22.5016 +4249 4 16.8779 36.1297 14.3524 2.35153 17.3801 14.4176 +4250 4 15.7232 35.3535 13.695 18.4875 1.24889 7.88518 +4251 6 45.2979 21.4768 12.0753 -61.6802 -17.7786 9.36854 +4252 4 45.9745 21.1118 11.5746 47.2025 -15.5682 -31.9287 +4253 4 44.6407 20.7302 12.0307 13.4445 30.1014 15.4365 +4254 6 51.647 5.33893 20.0992 17.3373 6.85256 40.4731 +4255 4 51.8423 5.82757 20.9547 -12.0569 -16.4938 -26.4666 +4256 4 50.8652 5.75336 19.736 -8.70547 10.2387 -6.49138 +4257 6 22.616 27.3068 0.953729 -12.5585 5.72419 11.7926 +4258 4 21.9912 27.9206 1.39427 2.62886 -13.0847 -9.82719 +4259 4 22.9744 27.8285 0.229956 6.91293 3.08187 -2.36887 +4260 6 46.8924 12.1405 22.3241 28.0037 10.4006 6.07885 +4261 4 46.5361 12.6234 21.5839 -13.5229 3.11861 -11.9828 +4262 4 46.2058 11.655 22.757 -25.8682 -9.85748 8.02404 +4263 6 33.7577 5.61095 25.2306 8.81298 -10.6825 9.18366 +4264 4 34.4045 5.06092 24.7535 -5.77276 6.31779 -0.0821136 +4265 4 33.06 5.8369 24.6155 -4.37455 2.20678 -7.03208 +4266 6 44.2424 18.1337 27.2287 35.5912 4.17402 -1.61274 +4267 4 44.1428 18.6708 26.4104 -1.15401 -3.8952 20.8354 +4268 4 45.2041 18.2132 27.495 -32.4507 -0.562547 -10.2772 +4269 6 5.27745 36.9951 29.0779 -48.9341 45.2857 -18.2185 +4270 4 4.83797 37.847 28.7 19.7525 -41.2711 21.6555 +4271 4 6.18662 37.2124 29.1987 31.023 4.60304 7.81739 +4272 6 20.0415 5.02171 38.9415 13.5567 -45.1901 -20.6947 +4273 4 19.673 5.46942 39.6755 -5.65499 20.9205 26.8401 +4274 4 20.3443 4.13258 39.2728 -11.021 23.424 -4.53385 +4275 6 17.9077 2.77821 33.872 -28.7289 7.66476 22.1934 +4276 4 18.5675 3.36618 33.4993 11.2764 5.36232 -3.32863 +4277 4 17.289 3.30252 34.4687 25.3234 -20.0176 -17.8345 +4278 6 5.56252 23.3664 22.3199 23.4646 34.0494 22.6536 +4279 4 6.31266 23.4141 21.6995 -10.6272 -11.1368 -5.13028 +4280 4 5.83055 24.0852 22.9498 -18.4748 -15.0058 -11.9197 +4281 6 12.7366 28.0136 40.0786 16.9267 17.0007 -14.1953 +4282 4 12.7736 28.981 40.2539 2.04889 -13.1204 -10.7842 +4283 4 13.1752 27.8683 39.2015 -12.0592 5.90979 20.7524 +4284 6 50.5208 38.8121 28.4283 -2.96204 -29.3557 2.62021 +4285 4 51.1161 39.4306 28.008 -0.383593 20.3423 -2.32338 +4286 4 49.7133 39.2143 28.7877 7.69194 10.1621 -6.76025 +4287 6 33.551 8.21903 17.8634 -36.1599 -47.4859 45.2019 +4288 4 33.9333 8.85376 17.3385 32.2471 57.3944 -47.1321 +4289 4 33.8604 7.38657 17.5128 5.83122 -9.97324 -0.737685 +4290 6 34.648 34.7105 17.7828 9.01761 -19.7832 -8.77749 +4291 4 35.1788 35.3328 18.2888 -3.00831 8.66808 4.62333 +4292 4 35.2883 34.0014 17.5711 -12.5093 2.94991 -0.39307 +4293 6 40.7261 5.27864 23.3991 8.21105 0.19251 11.4926 +4294 4 41.4259 4.93717 23.9966 -11.2767 2.88733 -17.4667 +4295 4 40.0598 4.58084 23.2941 1.87831 5.06613 5.43463 +4296 6 16.9137 27.769 14.4809 73.6258 -34.7175 -8.82476 +4297 4 16.0667 28.1115 14.4612 -62.8462 32.6704 -2.60496 +4298 4 17.5486 28.5101 14.4313 -15.9271 -1.25076 7.8547 +4299 6 29.0219 14.6595 5.00786 20.8741 -13.5443 13.1138 +4300 4 29.536 13.8229 4.89138 -12.0375 16.0826 3.98067 +4301 4 28.8859 14.7576 5.97494 -2.91261 0.0620574 -16.4413 +4302 6 36.854 17.7325 5.08016 4.48522 -18.3735 -43.8449 +4303 4 36.2168 18.3553 5.39001 -11.7806 18.6728 17.0618 +4304 4 36.8305 17.8608 4.09391 11.7548 -5.76061 25.8999 +4305 6 27.7142 25.5094 34.8662 20.7401 -29.3529 -12.6468 +4306 4 28.3997 25.1535 35.4786 -13.7878 13.2187 -9.69645 +4307 4 27.3728 26.292 35.2699 -5.77421 14.8272 18.3022 +4308 6 24.7481 17.2805 18.0642 -3.31447 -10.4308 -2.46491 +4309 4 25.3087 17.9154 18.5049 2.27957 10.048 8.00722 +4310 4 24.0564 17.0505 18.7104 4.01172 4.3516 -6.8818 +4311 6 30.1789 1.58441 5.83411 4.12275 19.8646 -71.4749 +4312 4 29.4821 1.85802 6.42075 -6.9839 1.28517 8.89789 +4313 4 29.959 2.0434 4.91278 6.77151 -29.6581 61.3265 +4314 6 37.452 25.891 8.43789 -40.1641 -31.4732 50.6902 +4315 4 38.334 25.9927 8.78667 20.6785 -4.95116 -4.15592 +4316 4 36.9881 25.2791 9.14634 19.6253 32.8331 -49.0064 +4317 6 24.7604 7.00734 2.27008 32.0581 9.85747 -12.4546 +4318 4 25.4028 6.31463 2.48931 -5.40489 7.62931 7.6933 +4319 4 23.9158 6.58667 2.26874 -21.5893 -3.78057 4.11792 +4320 6 25.7887 38.8506 10.7619 -30.5475 28.1992 -59.3139 +4321 4 26.3103 38.4194 11.381 38.5207 -12.4255 48.7922 +4322 4 26.1525 39.7259 10.4932 -1.18865 -9.03037 15.3914 +4323 6 0.555207 13.578 28.1388 12.6332 42.7054 11.738 +4324 4 0.341766 12.7807 27.7179 -10.1825 -36.9478 -16.4943 +4325 4 0.413626 13.4435 29.0864 -5.17296 -1.28815 -2.85065 +4326 6 20.4105 17.1191 12.037 -17.9302 -38.4569 -26.5492 +4327 4 20.2295 17.2547 12.9605 -1.34068 5.07474 20.9983 +4328 4 19.8884 16.3005 11.7926 16.4515 20.0565 4.33162 +4329 6 30.9925 7.37797 16.6653 29.7996 22.3073 3.61878 +4330 4 31.2643 7.03844 15.7784 -2.63758 10.9944 17.123 +4331 4 31.7569 7.94595 17.0261 -27.6116 -29.8279 -14.8225 +4332 6 10.2093 5.78517 12.1714 32.5037 6.96704 58.397 +4333 4 10.1014 6.35617 11.4591 -8.08786 32.1119 -50.7901 +4334 4 9.65707 5.06197 12.024 -36.7963 -41.1043 -15.4671 +4335 6 18.4347 31.3493 24.155 3.48135 -6.25246 2.65688 +4336 4 18.4439 30.3878 24.2879 -2.95335 1.71216 0.944019 +4337 4 18.3198 31.7316 25.0273 -3.67252 2.09543 1.27238 +4338 6 27.8948 29.2525 29.2666 2.33504 21.8021 -21.5937 +4339 4 28.3627 29.5914 28.4251 -11.9103 -18.4763 37.4515 +4340 4 28.5196 28.9609 29.9463 14.9294 0.890267 -8.6061 +4341 6 38.3738 15.4456 29.791 12.9945 -28.6313 15.0543 +4342 4 38.0891 14.5036 30.0544 22.1369 39.5396 -7.74746 +4343 4 39.2957 15.632 30.1541 -37.4531 -3.97597 -10.3113 +4344 6 21.7041 34.7992 5.56934 -10.1436 -56.1371 25.2208 +4345 4 21.4621 33.8673 5.89439 16.7439 32.0975 -19.9868 +4346 4 20.9431 35.2741 5.907 -2.46203 13.3807 -4.97838 +4347 6 18.2064 16.8274 1.01093 1.02147 5.09087 9.91972 +4348 4 17.6405 17.264 0.353478 -0.489627 -6.58546 6.49815 +4349 4 17.8529 17.0628 1.89865 0.517006 0.361128 -13.8735 +4350 6 43.5166 18.4972 39.3436 16.5286 13.9247 -42.0759 +4351 4 43.0101 19.1966 39.7112 -21.9319 15.1254 24.622 +4352 4 43.7095 18.933 38.4597 1.00685 -29.3013 20.2287 +4353 6 17.7976 10.0688 35.5434 7.86102 19.599 -20.2005 +4354 4 17.8945 9.40709 36.2105 4.74187 -18.2058 11.3424 +4355 4 18.5459 9.97323 34.9151 -16.2901 -5.18221 9.2364 +4356 6 36.5889 30.5599 29.0828 -33.0481 48.6405 -12.465 +4357 4 36.5132 31.4977 28.7143 1.54088 -37.0728 8.50934 +4358 4 37.4982 30.324 28.9756 25.7485 -11.7594 -3.68806 +4359 6 38.4943 35.9682 10.4222 10.3079 16.2999 40.226 +4360 4 38.6552 36.6966 11.1228 -3.33458 -34.9071 -25.8136 +4361 4 38.3509 35.1294 10.9235 4.16648 17.1849 -3.98913 +4362 6 43.4036 18.8037 34.3607 -18.7725 -42.8138 41.3108 +4363 4 42.9709 18.1893 33.7432 11.3097 10.906 -2.86187 +4364 4 43.2777 18.3171 35.2411 6.94038 29.5352 -30.5758 +4365 6 11.0585 40.2128 6.10885 -15.7783 5.94868 1.16987 +4366 4 11.5965 40.9262 6.45194 10.3679 4.26541 4.32644 +4367 4 10.1443 40.5526 6.13585 6.40705 -5.05479 -5.29954 +4368 6 48.3342 13.7493 24.4707 -3.46168 30.4962 28.8754 +4369 4 47.8576 13.3588 23.754 -13.8134 -6.92474 -20.9085 +4370 4 47.8711 14.5963 24.7134 14.7345 -25.1065 -10.1999 +4371 6 1.47205 25.7712 23.7829 0.184952 23.7651 -2.41746 +4372 4 0.854396 26.4618 23.4919 -3.79407 -11.1699 -2.17794 +4373 4 2.13056 26.3319 24.2122 9.67536 -12.9921 7.11562 +4374 6 20.5856 0.045789 21.1048 4.96875 -22.7073 -7.43464 +4375 4 19.8117 0.249922 21.5931 -19.4423 21.7426 16.1957 +4376 4 20.4519 41.001 21.0443 13.8042 -0.350206 -3.82588 +4377 6 37.6675 12.896 30.7055 18.9575 -14.1068 -43.1025 +4378 4 37.1872 12.5493 29.907 3.14127 2.53034 24.3729 +4379 4 37.0391 13.1763 31.3358 -31.377 6.23238 20.3235 +4380 6 49.4665 17.3801 9.24655 -8.32961 25.946 -15.5009 +4381 4 48.5345 17.665 9.32633 16.3924 -11.5392 1.15372 +4382 4 49.8219 17.9883 8.54454 -1.98957 -21.6031 19.5257 +4383 6 34.3643 5.3502 17.1421 32.952 7.78829 -18.2658 +4384 4 34.6245 5.26975 16.1857 -14.4704 2.64329 20.4158 +4385 4 33.4298 5.20109 17.2262 -20.6176 -11.2241 -0.901893 +4386 6 14.7832 27.6655 0.085624 -10.3553 13.8949 -22.792 +4387 4 14.1034 27.8892 41.3249 2.03342 -11.2849 14.5146 +4388 4 15.1757 28.5319 0.287496 2.39463 -6.00136 9.68974 +4389 6 48.8635 15.5211 20.7504 -7.30397 3.37214 15.1279 +4390 4 49.1252 16.3754 20.4371 0.183023 13.7927 -3.76167 +4391 4 49.1585 14.9241 20.0762 3.93917 -17.6947 -14.7742 +4392 6 23.8074 40.3851 20.3877 -2.3041 21.5375 32.1864 +4393 4 23.5266 40.991 21.1382 8.45078 -18.9812 -28.3519 +4394 4 24.6929 40.0818 20.645 -4.8729 5.63426 -4.96266 +4395 6 35.18 31.4993 13.7142 -38.6695 32.0432 -41.3249 +4396 4 34.2219 31.3119 13.4889 30.0091 9.93153 3.95626 +4397 4 35.4367 30.7845 14.243 12.3636 -35.8089 30.5679 +4398 6 10.9775 9.01115 39.5206 -26.3812 35.8658 -19.2594 +4399 4 10.5557 9.91556 39.5205 15.5031 -28.3669 -8.85108 +4400 4 11.1542 8.87096 40.4393 5.31517 -3.54045 10.232 +4401 6 53.2061 4.88103 16.6049 -20.6689 -12.7794 3.6937 +4402 4 53.6782 5.3887 17.2239 33.7717 25.1716 19.5104 +4403 4 52.5676 4.51498 17.2255 -11.3933 -13.1169 -19.2452 +4404 6 7.83562 33.8039 26.1496 42.0062 50.3869 -17.047 +4405 4 7.62463 34.1533 27.0155 -6.33847 -9.39794 9.82588 +4406 4 8.42034 34.5749 25.7852 -30.6961 -50.8642 6.91563 +4407 6 31.3279 27.9472 6.28298 4.37835 -19.3247 -9.6219 +4408 4 31.922 27.5111 6.93657 -10.4846 5.09347 -11.9486 +4409 4 31.1129 27.3323 5.53276 6.79934 9.76999 15.6259 +4410 6 31.3655 2.17383 41.055 18.9421 -1.98994 34.5993 +4411 4 31.8109 2.17902 0.04034 -17.0754 7.04602 -28.7946 +4412 4 31.2404 1.23747 40.9086 -7.00813 -7.80206 -8.22245 +4413 6 33.7652 4.25739 35.9001 -31.2863 -13.3655 20.8802 +4414 4 34.2485 3.80076 36.6104 5.56552 8.36292 -9.80816 +4415 4 32.8077 4.13792 36.1863 30.7439 3.51509 -16.9094 +4416 6 47.9725 16.0636 29.8584 -12.289 -4.0311 -5.35812 +4417 4 48.7208 16.4163 30.3732 -4.13056 -10.8519 0.408936 +4418 4 47.3533 15.5947 30.4559 16.7379 8.85318 -0.563064 +4419 6 49.3385 10.0935 28.5885 -11.8118 4.56009 -13.0989 +4420 4 48.5886 10.6638 28.8239 3.51911 -4.5157 1.44109 +4421 4 49.3924 10.1159 27.6088 6.69909 -1.91925 15.8757 +4422 6 21.4187 27.7693 29.76 2.80336 -20.4787 -6.37736 +4423 4 21.861 27.2354 30.4624 -7.84738 15.6574 -13.8161 +4424 4 21.1828 28.6282 30.0799 2.10219 20.3695 17.9057 +4425 6 11.6757 39.482 25.8517 13.5538 20.9417 -1.29545 +4426 4 12.2965 38.7786 26.0889 -7.12508 -2.9493 -2.05027 +4427 4 10.8193 39.0846 25.7116 -11.9056 -6.20494 0.0112269 +4428 6 22.9798 39.311 7.85817 -12.7601 -4.86939 -3.04246 +4429 4 22.3059 38.6219 7.95844 1.92638 3.98273 0.136758 +4430 4 22.5772 40.0658 8.31757 9.04497 -1.85468 3.82529 +4431 6 42.5415 35.9278 31.3391 13.0935 -70.9729 -20.1514 +4432 4 42.6447 35.4696 30.4714 -5.52665 5.17936 25.8951 +4433 4 42.5102 36.7973 31.0384 -8.93799 60.9387 2.27408 +4434 6 33.663 14.7412 3.98499 30.4225 -17.693 -39.6888 +4435 4 32.8564 15.2185 4.09596 -24.3526 16.5192 2.50389 +4436 4 33.8944 14.7916 3.00116 -11.9532 1.40502 32.6284 +4437 6 36.697 8.6017 17.5153 18.7294 -29.9333 -4.55465 +4438 4 37.1702 7.95911 16.9159 -11.687 24.5338 13.7544 +4439 4 36.2734 9.25409 16.9543 -7.54123 3.80926 -6.08989 +4440 6 20.8295 32.4146 17.3309 -48.7404 -21.5825 11.0081 +4441 4 20.1664 32.9726 16.9048 10.2664 9.72211 -3.82622 +4442 4 20.2271 31.8015 17.8465 35.2036 12.7196 -8.50107 +4443 6 20.7003 35.3218 14.1083 -3.44914 -18.0461 -19.2112 +4444 4 21.3182 35.5386 13.4099 3.08163 2.90557 -13.4495 +4445 4 20.919 35.9437 14.7754 1.56244 13.5022 22.2067 +4446 6 20.2323 2.51936 40.1651 -9.22326 -14.3688 36.1644 +4447 4 19.7926 2.34354 41.0434 13.5524 6.30823 -28.5037 +4448 4 20.7516 1.7186 40.0171 -1.27786 1.50094 -7.75906 +4449 6 15.0477 14.4672 0.24789 12.9865 -5.55034 -72.7807 +4450 4 15.4827 13.6954 41.6877 -12.87 20.0829 29.6139 +4451 4 15.2186 15.2036 41.5094 -2.93016 -13.2387 23.097 +4452 6 24.8149 37.3373 18.5213 2.43631 -2.68492 27.9859 +4453 4 24.4361 37.9203 17.8611 -0.249038 9.91659 1.71419 +4454 4 24.5604 37.6468 19.4234 0.486379 -6.00228 -23.279 +4455 6 3.16989 27.7944 5.24229 1.80682 -16.6913 61.515 +4456 4 2.664 27.92 6.09489 -0.254446 2.50987 -32.3978 +4457 4 4.0252 27.4816 5.63916 -14.135 1.37322 -28.2843 +4458 6 37.1257 39.0598 36.0573 4.58816 40.5807 23.3296 +4459 4 37.5599 39.5885 36.7783 -22.7086 -1.13864 -22.8071 +4460 4 37.5439 38.2379 36.1828 13.5973 -37.3165 -5.96047 +4461 6 41.3477 16.3672 3.84024 25.8131 6.72768 37.2631 +4462 4 41.4431 17.3182 3.89206 -17.3786 8.01961 -13.1803 +4463 4 42.0046 16.1549 4.54461 -14.0821 -19.2698 -21.0799 +4464 6 15.5755 3.1684 35.3585 1.47298 2.70845 -61.2084 +4465 4 15.1145 3.59171 34.5864 10.479 -16.2188 17.3147 +4466 4 15.2032 3.60881 36.0782 -15.9672 22.7619 40.5269 +4467 6 33.1731 24.2438 7.96729 6.41569 -10.7526 14.1331 +4468 4 33.3408 24.6773 7.1445 11.9115 -7.07525 -26.7187 +4469 4 32.5824 24.8707 8.33408 -19.4303 14.6961 21.7816 +4470 6 35.865 29.7374 15.5979 -29.8607 35.3275 -32.1308 +4471 4 36.7747 29.6672 15.7703 43.701 -12.5229 16.5971 +4472 4 35.3562 29.0371 15.9739 2.56537 -15.478 18.0667 +4473 6 17.5843 36.8354 41.8728 12.1708 -5.57123 -52.5088 +4474 4 18.1833 36.773 0.675699 12.2604 -1.93512 36.5948 +4475 4 18.2359 36.8623 41.125 -21.8566 7.06165 11.6698 +4476 6 26.5622 4.14672 31.1307 -32.6289 -51.1506 -31.7953 +4477 4 27.2582 4.59627 31.5457 41.9615 24.0313 17.3243 +4478 4 26.8928 3.23766 30.8727 -4.86114 29.783 15.5489 +4479 6 31.9552 1.33198 34.4369 -14.3248 -8.90334 35.5546 +4480 4 32.7269 1.15305 34.9944 8.32726 6.02564 -17.2377 +4481 4 31.2642 1.08685 35.0838 -0.545778 4.81468 -20.3916 +4482 6 24.491 14.7534 2.38457 33.2042 -23.9469 17.2683 +4483 4 24.2753 13.9637 2.92779 -7.56186 18.0622 -11.5291 +4484 4 25.4626 14.8414 2.55985 -20.2114 8.54272 -9.97318 +4485 6 25.7566 20.9055 27.5389 -1.15091 7.1508 6.95521 +4486 4 25.459 20.6057 28.4261 8.17968 -1.38894 -17.9407 +4487 4 25.6371 21.8685 27.5748 1.97223 -1.15564 -2.97875 +4488 6 18.1445 40.1527 30.6395 17.3729 -20.3781 15.2884 +4489 4 18.5141 39.2638 30.8544 -10.5973 16.1604 -9.36512 +4490 4 18.9393 40.7073 30.6583 -6.94059 7.54086 -5.9327 +4491 6 46.7889 23.8914 24.5979 7.31075 41.4222 -46.8858 +4492 4 46.2898 24.602 24.0741 10.6002 -32.8666 22.2289 +4493 4 47.4121 23.5287 23.9473 -6.99108 -0.957122 4.26591 +4494 6 45.6201 22.6921 26.5067 -14.1777 -10.0967 -12.8229 +4495 4 46.0372 22.9342 25.6668 -2.41585 -1.26552 16.8561 +4496 4 46.0784 23.1676 27.2003 -0.61408 1.28207 1.11474 +4497 6 20.1006 4.48803 26.6974 -40.8522 40.1383 42.8029 +4498 4 20.2489 5.43817 26.4853 8.37449 -26.4011 -0.951475 +4499 4 20.6602 3.93368 26.2205 34.0606 -24.4352 -38.1565 +4500 6 35.278 26.5864 12.552 0.280065 20.4825 10.9931 +4501 4 35.6728 25.7022 12.4634 2.08478 13.3641 8.87461 +4502 4 35.7774 27.1222 13.2104 -5.20465 -19.6779 -15.4464 +4503 6 3.25879 33.9669 12.2907 -5.01808 -25.4739 5.3677 +4504 4 2.34263 33.6224 12.3201 4.20809 12.7539 -0.381501 +4505 4 3.26735 34.9165 12.3326 -4.58918 17.9212 0.78916 +4506 6 36.6873 1.27899 25.5756 -31.8717 2.25298 32.7844 +4507 4 37.6116 1.37326 25.7779 18.4499 5.6721 -4.77344 +4508 4 36.2122 1.51788 26.4163 6.97172 -2.04149 -25.7728 +4509 6 16.8705 4.65685 24.0413 -35.5309 2.76318 -23.9776 +4510 4 15.8575 4.70434 23.9217 47.0687 -0.0954558 1.21401 +4511 4 17.247 4.33879 23.186 -5.50277 -2.28941 17.9023 +4512 6 39.6565 15.0715 7.80572 25.6093 19.6796 32.1194 +4513 4 39.2854 14.2576 8.13712 -9.42359 -13.1845 -9.18942 +4514 4 39.3628 15.2517 6.91527 -5.26665 -12.4192 -5.15573 +4515 6 9.97948 20.1659 2.91877 -9.38613 14.9664 11.2777 +4516 4 9.63877 20.6452 2.15027 4.12295 -11.9706 -3.67253 +4517 4 9.85969 19.2106 2.80597 1.71997 13.0916 -4.74013 +4518 6 23.4135 4.6314 15.2717 1.19087 -47.3757 24.1847 +4519 4 23.6596 4.57091 14.3636 3.27412 12.4021 -25.8415 +4520 4 23.0767 5.481 15.4712 -5.64379 31.4202 -0.243197 +4521 6 23.5143 41.6409 17.9193 15.1077 8.25095 -6.6202 +4522 4 23.8837 41.2632 18.7444 -17.9015 4.85421 -1.14363 +4523 4 22.6477 0.129763 18.1032 2.89941 -5.9973 3.37217 +4524 6 30.9257 4.8197 1.33225 52.4556 82.2644 21.8498 +4525 4 30.6067 4.04082 1.0087 -28.5575 -73.6424 -29.1188 +4526 4 31.8008 4.99709 0.898826 -20.2281 -12.9509 7.44496 +4527 6 29.2107 33.7595 18.6102 73.0072 -21.2941 -2.29721 +4528 4 30.2072 34.0216 18.5444 -47.9733 -6.17517 5.28057 +4529 4 28.7323 34.5281 18.37 -21.0864 31.3556 1.11974 +4530 6 23.1159 16.7161 3.6681 15.0693 -22.2232 4.2808 +4531 4 23.7494 16.3853 2.99745 -15.1451 3.0429 8.25243 +4532 4 23.0882 17.666 3.59926 -2.15966 11.8771 -4.335 +4533 6 34.9011 26.7664 31.7501 -1.76717 8.52767 -40.8429 +4534 4 35.037 27.6398 31.3273 1.29043 -2.59798 26.5044 +4535 4 34.999 26.223 30.9552 -0.698038 -3.54606 8.98008 +4536 6 7.10213 40.7731 20.9713 24.4432 1.2064 -5.23395 +4537 4 6.57619 40.3882 20.2802 -20.054 -4.79313 -9.64846 +4538 4 7.95521 40.8692 20.51 0.818491 4.17448 7.60026 +4539 6 52.4557 9.69054 11.9333 -13.8891 -19.4181 -13.3487 +4540 4 52.1298 8.88818 11.4535 9.48574 25.0976 13.8313 +4541 4 53.1611 10.0725 11.3936 -7.122 -1.8527 1.23238 +4542 6 12.0235 32.7598 27.7442 3.70099 -7.78602 -3.89203 +4543 4 11.3626 32.1501 27.3892 -5.86407 9.3821 3.02313 +4544 4 12.7405 32.6461 27.1218 9.18069 3.19616 2.31322 +4545 6 15.7918 18.546 0.850378 10.8461 -1.95532 -11.5883 +4546 4 16.438 18.9813 1.41668 1.29405 -2.87095 0.147979 +4547 4 14.9753 18.6242 1.3119 -21.1882 -0.0291689 9.92309 +4548 6 30.9967 13.9378 7.42939 11.475 1.61738 -44.5395 +4549 4 31.0432 13.5913 6.48715 -7.7997 1.97415 36.5778 +4550 4 31.6719 14.6391 7.43931 -7.46887 -7.66354 10.6483 +4551 6 23.9383 39.564 3.55488 34.3001 -22.0749 -10.0269 +4552 4 24.3437 38.8163 4.07249 -17.2972 16.8542 -11.2744 +4553 4 24.6493 39.7352 2.88999 -19.8697 7.819 10.5959 +4554 6 53.2452 13.9576 2.00229 -14.7116 -5.90049 -8.44118 +4555 4 54.0493 14.3984 2.24709 19.6807 0.169927 9.22775 +4556 4 52.9645 14.4205 1.20429 2.95034 -7.59818 -1.70329 +4557 6 29.4557 26.4275 7.80964 12.1022 6.02758 -9.79702 +4558 4 29.9353 26.7368 7.00545 -17.6775 -4.91001 19.2628 +4559 4 28.525 26.2807 7.58748 -5.08244 6.84096 -3.37299 +4560 6 24.6247 23.6022 31.0889 -22.8452 23.3962 -39.3716 +4561 4 23.7242 23.1866 30.9343 31.0198 16.8155 5.56769 +4562 4 24.7802 24.3072 30.3632 -7.32447 -41.3429 34.091 +4563 6 33.6649 19.3163 40.5091 -6.65541 -1.27585 7.81728 +4564 4 33.8354 18.657 41.2044 -1.67667 1.74775 -3.87809 +4565 4 34.3105 19.1562 39.8145 2.0445 4.20075 -4.1701 +4566 6 0.559384 35.9874 14.2134 5.8565 -19.6842 -1.82955 +4567 4 1.23941 35.9463 14.8996 -3.202 15.0395 2.84586 +4568 4 0.030681 36.7785 14.2979 -4.01885 14.7851 6.49139 +4569 6 7.05661 12.759 15.7779 -22.8667 -6.52104 17.6379 +4570 4 6.34583 12.5966 16.4564 20.9558 0.33122 -21.552 +4571 4 6.91757 12.0848 15.0954 -2.34629 3.44815 6.08752 +4572 6 7.88282 3.87818 22.4173 5.89555 -44.5054 15.1514 +4573 4 7.49019 4.56914 21.9267 -7.80716 26.896 -25.5563 +4574 4 7.61791 3.03791 21.9647 5.08594 18.6769 15.1101 +4575 6 50.7471 32.0888 16.2401 1.83727 42.1646 -7.06137 +4576 4 49.8752 31.8312 16.5285 -7.29916 -4.21179 -0.512004 +4577 4 50.6362 33.057 15.9791 5.96194 -37.4522 8.78354 +4578 6 15.303 18.2089 30.059 10.7923 -22.0796 25.2673 +4579 4 14.9011 18.5061 29.2675 -14.0638 14.0876 -27.3921 +4580 4 14.9173 17.3208 30.1974 9.34767 8.93092 3.04247 +4581 6 36.7231 25.4597 33.3812 -54.2725 16.2506 -34.9161 +4582 4 35.9173 25.838 32.8237 55.5216 -11.0114 39.6871 +4583 4 36.747 24.5432 33.1027 5.79642 -6.85026 5.14009 +4584 6 16.5358 21.8507 20.2615 -17.2006 3.10996 -10.5852 +4585 4 16.5318 20.9271 19.9881 4.62491 -6.39719 -1.16283 +4586 4 16.2171 22.3466 19.4835 8.40466 -0.269645 8.83911 +4587 6 44.2784 3.11614 30.075 -4.29151 -10.9085 31.9498 +4588 4 44.2908 2.23086 29.7056 -5.3385 -9.83615 -1.81045 +4589 4 44.5205 3.68982 29.3775 9.49019 22.102 -29.428 +4590 6 51.0822 14.1295 27.7742 -18.732 -33.3382 -1.30318 +4591 4 51.215 15.0658 27.7997 -1.99026 24.8352 -0.164216 +4592 4 50.1181 13.9695 27.6298 18.0185 9.91077 0.913588 +4593 6 54.1414 15.8836 27.1251 18.1892 -50.717 -21.9912 +4594 4 54.5758 14.9905 27.2793 -7.90108 34.3346 13.352 +4595 4 53.8259 15.7459 26.2068 -12.5208 17.6482 15.4671 +4596 6 26.7107 15.1629 34.529 26.3006 32.6175 -12.2305 +4597 4 26.7089 16.144 34.4655 -8.86078 -18.0829 7.52702 +4598 4 27.5163 14.9973 34.009 -10.4907 -11.0891 -0.654257 +4599 6 34.6699 2.22267 27.4725 27.1341 -12.2799 29.337 +4600 4 34.3153 1.93716 28.3227 7.08088 3.88889 7.09202 +4601 4 33.8991 2.25298 26.9555 -28.541 9.30381 -28.496 +4602 6 36.3083 17.6409 40.3953 7.68303 1.60807 9.57574 +4603 4 35.716 17.1791 39.8253 -12.5236 -4.37947 -14.4862 +4604 4 36.6569 16.9265 40.9504 1.18426 15.263 2.6664 +4605 6 26.2972 0.194896 33.0957 0.945324 -1.75644 -10.1569 +4606 4 26.0926 0.771392 33.8475 -8.68516 2.0119 1.91424 +4607 4 25.4691 41.6865 32.8295 -8.00507 -1.67316 12.192 +4608 6 5.19113 35.5773 31.6357 23.2413 -27.7984 27.0466 +4609 4 6.1476 35.7159 31.7435 -10.1506 4.22761 6.12862 +4610 4 4.96861 36.095 30.8978 -11.7512 22.2076 -38.0194 +4611 6 20.2191 22.0354 35.1304 9.30742 -6.19625 19.4235 +4612 4 19.9844 21.2003 34.7289 -5.16022 -6.81034 -3.33987 +4613 4 20.4782 21.7596 36.0473 -3.02096 9.85719 -25.9724 +4614 6 15.9251 36.5949 36.947 -9.13121 -30.7472 31.1466 +4615 4 16.4837 37.3712 37.0549 6.13876 -3.03661 -2.05614 +4616 4 16.031 36.0658 37.8159 -5.1453 16.1721 -39.9007 +4617 6 30.9484 22.4015 3.56131 11.993 -60.8988 -15.4947 +4618 4 31.1008 22.6958 4.44557 1.55935 5.74187 27.4751 +4619 4 31.2551 21.4217 3.58407 -13.4398 43.4536 -6.61432 +4620 6 47.0429 8.40936 14.2086 -4.42011 -15.6298 -34.0486 +4621 4 46.2603 8.29509 13.606 17.325 5.05196 18.7602 +4622 4 47.7698 7.89697 13.7682 -18.8904 11.0332 12.0247 +4623 6 34.1011 18.6159 3.148 0.361877 23.965 35.4915 +4624 4 34.6363 18.3397 3.89922 -0.845538 -0.743075 -4.07575 +4625 4 34.3812 18.1265 2.40098 2.04544 -17.9565 -29.3984 +4626 6 26.7996 25.3961 12.3408 -30.8906 -54.2954 26.5725 +4627 4 27.3117 26.1608 12.4557 20.536 44.4803 3.39785 +4628 4 26.6414 25.0259 13.2528 6.28377 9.49183 -30.6151 +4629 6 22.6108 25.7845 30.8845 17.3255 -0.303924 3.7754 +4630 4 23.4288 25.6954 31.4132 -11.344 -1.13015 -1.03332 +4631 4 22.2314 24.9052 30.7722 1.09512 -5.6623 7.4309 +4632 6 23.6311 9.76276 35.7585 -2.90797 -4.19552 -4.78319 +4633 4 22.8314 10.2832 35.6581 -5.74139 5.63622 4.02691 +4634 4 23.3139 8.86685 35.4998 11.2809 19.0625 6.63709 +4635 6 10.4076 36.7742 9.64242 -28.436 -9.9846 9.32351 +4636 4 9.50067 36.3875 9.59353 19.7531 11.7612 -0.53903 +4637 4 10.7226 36.8301 8.7426 3.69205 5.92187 -13.8772 +4638 6 4.00038 32.4265 25.8669 22.0714 10.4661 11.4497 +4639 4 4.38844 32.9375 25.1422 -1.34031 3.54398 1.69886 +4640 4 3.2706 31.9516 25.4996 -17.8371 -17.4963 -10.4987 +4641 6 29.085 26.0296 18.6527 19.273 -47.5776 11.2122 +4642 4 28.2115 26.0231 19.0264 -21.1607 3.13806 -0.423844 +4643 4 29.4632 25.1291 18.9323 -7.10954 42.4601 -14.5827 +4644 6 15.3089 1.3255 27.9792 -24.1234 20.5069 -17.5654 +4645 4 15.0496 0.974163 27.1169 2.04641 -4.01433 11.5068 +4646 4 14.7355 2.12388 28.0804 19.9995 -12.8223 4.08523 +4647 6 48.6106 2.88816 22.9655 -1.26722 3.55247 -0.201848 +4648 4 48.4165 2.02818 22.6182 -14.5439 -12.5884 3.03438 +4649 4 49.5001 2.98572 22.6432 10.4652 10.9023 -5.33271 +4650 6 53.0075 0.36099 19.7296 11.424 -8.43987 -8.95848 +4651 4 52.5965 41.9022 20.5162 -3.41206 4.78179 6.33318 +4652 4 52.3731 0.223553 19.0136 -6.83989 5.16364 0.289704 +4653 6 1.41074 17.5036 17.9462 -15.7932 -16.9445 -5.36496 +4654 4 1.29993 17.3585 17.0019 -2.92928 12.5396 -5.88676 +4655 4 1.38271 16.6004 18.2823 6.65411 -3.00458 14.0519 +4656 6 37.9084 19.0323 37.6056 -38.9323 8.68785 -13.5971 +4657 4 36.9858 18.7285 37.7384 11.3307 8.89304 -0.372118 +4658 4 38.4207 18.4342 38.1195 19.3518 -17.7067 16.118 +4659 6 26.9813 30.3571 38.0896 -0.527767 18.5171 -30.3811 +4660 4 26.1212 30.285 37.6565 1.23907 -9.17466 9.80696 +4661 4 27.2764 31.2069 37.701 2.1524 -13.2267 12.8694 +4662 6 20.0955 18.5722 3.03696 10.9017 21.9571 9.92937 +4663 4 20.0263 17.806 3.59422 -10.4522 -23.2015 2.62566 +4664 4 20.8322 19.0363 3.46766 -4.52129 0.073665 -16.3651 +4665 6 35.0841 6.94694 4.08385 8.40312 -14.6319 10.4582 +4666 4 35.6826 7.16069 3.3578 -1.64356 4.34706 -6.00978 +4667 4 34.2613 7.42764 3.99145 -7.61312 4.93718 -6.31016 +4668 6 22.2176 37.0878 31.2599 -35.8324 13.882 69.7054 +4669 4 22.1593 36.8558 30.3798 -4.04212 -13.8909 -61.3413 +4670 4 21.2552 37.1952 31.5589 44.4461 1.84169 -14.4682 +4671 6 12.3904 22.3711 41.8265 33.9103 21.3816 -17.5574 +4672 4 13.0623 23.0096 41.4404 -31.3175 -17.017 24.3472 +4673 4 11.7392 22.2302 41.1411 -5.71588 1.3909 -0.895108 +4674 6 43.2333 30.3145 23.1566 26.412 30.0652 1.94466 +4675 4 44.1443 29.9954 22.911 -23.9673 11.2944 4.28313 +4676 4 43.3588 31.2906 23.3811 -4.98348 -33.6726 -4.24118 +4677 6 16.5316 8.07904 16.6592 -13.1305 -2.58289 1.30551 +4678 4 16.426 8.46358 15.7881 -7.07274 -4.02537 -8.52635 +4679 4 17.4421 8.27811 16.8595 11.8389 2.77268 11.6749 +4680 6 10.0527 8.64979 31.7837 -8.97334 17.7557 -57.5223 +4681 4 10.1312 7.90747 32.3291 5.58005 -27.1767 37.8097 +4682 4 10.1183 9.47003 32.2578 1.92783 9.29621 23.4619 +4683 6 10.1389 6.52097 25.6279 25.2027 -9.57639 0.964906 +4684 4 9.42987 6.19895 26.1639 -19.2857 -8.54063 7.31181 +4685 4 9.7626 7.17299 25.0306 4.07146 -2.80849 4.96109 +4686 6 49.8614 7.23714 25.5252 -17.9172 7.62946 -5.56104 +4687 4 50.0467 6.31121 25.4422 2.69032 -18.6529 -6.42341 +4688 4 50.6907 7.63095 25.75 18.9978 12.6416 8.6826 +4689 6 18.4677 37.5766 33.9365 -27.5019 7.45217 1.11424 +4690 4 17.6855 38.1606 34.0956 24.1544 -3.52274 -4.16364 +4691 4 18.0518 36.7105 34.0373 4.53854 -5.63623 -1.47673 +4692 6 32.1991 34.7999 39.2511 37.7035 -28.7103 22.0041 +4693 4 32.3976 34.2973 40.087 0.14143 15.1618 -21.7552 +4694 4 31.3182 35.0784 39.3573 -42.2601 10.9481 4.26487 +4695 6 49.5371 23.9083 4.45427 26.1113 1.30104 -36.4507 +4696 4 49.7626 23.2251 5.06121 8.22711 -23.3511 16.8473 +4697 4 48.7895 24.3154 4.8182 -37.5883 23.1909 21.4935 +4698 6 6.05615 24.4755 33.9372 -3.62864 21.1406 1.2609 +4699 4 6.78781 23.8493 33.8811 -5.98028 -5.90455 -1.42734 +4700 4 5.44033 24.2071 34.6424 10.5748 -4.32926 -7.84557 +4701 6 1.71417 22.9797 24.1919 12.9465 25.751 -13.942 +4702 4 1.74027 23.9063 23.8744 -7.21984 -9.04225 7.93975 +4703 4 0.785802 22.7901 24.3299 -10.4675 -5.82386 8.34916 +4704 6 12.4544 16.5695 32.338 -33.1179 2.9171 31.5337 +4705 4 13.1434 15.995 32.5512 52.391 -27.2499 -12.3732 +4706 4 11.9701 16.4097 33.1768 -13.251 25.8897 -21.4653 +4707 6 21.3776 37.3784 27.9508 -6.73969 12.2577 23.3137 +4708 4 21.2203 37.3231 27.0262 1.16773 -1.52428 -34.5533 +4709 4 20.718 38.0458 28.2038 6.71566 -1.73666 8.03222 +4710 6 27.2299 40.8388 28.8031 2.48401 0.937021 1.60569 +4711 4 26.5367 41.5089 28.9565 6.65702 -12.2841 2.86921 +4712 4 27.4065 40.3185 29.6035 -12.9999 8.55112 -0.224288 +4713 6 0.993205 21.7261 13.5372 -53.3037 2.48171 -36.3839 +4714 4 1.86429 21.8093 13.8237 52.7771 -6.56786 29.3883 +4715 4 0.417346 21.4203 14.2472 8.63216 3.11646 10.526 +4716 6 22.3067 2.58146 8.73662 29.448 -13.2509 35.6107 +4717 4 22.9722 3.05705 8.24165 5.16658 9.50374 -8.2335 +4718 4 21.5154 2.5876 8.23764 -24.8297 4.23497 -21.3736 +4719 6 29.9953 17.8456 8.24313 -2.433 8.62767 -9.90081 +4720 4 29.054 17.6713 8.30654 -5.44558 -4.70631 2.21427 +4721 4 30.3746 17.4275 9.01982 5.69521 -3.15286 8.62416 +4722 6 3.62819 37.7118 25.7099 -17.1271 -24.8271 -10.3244 +4723 4 4.40422 37.1524 25.7956 9.9921 4.76654 4.66524 +4724 4 2.941 37.0477 25.4485 4.12723 25.8155 6.09629 +4725 6 26.809 27.648 36.3589 -37.7802 -17.2474 29.8166 +4726 4 26.8014 28.1831 35.5758 -1.13827 16.217 -13.4241 +4727 4 25.8725 27.5642 36.7259 28.3017 7.35189 -21.1707 +4728 6 13.3559 25.3099 38.116 1.93465 -14.8526 16.0582 +4729 4 13.2959 24.3789 38.4372 3.98877 20.6101 -4.99041 +4730 4 14.1146 25.694 38.605 -5.66874 -3.07699 -9.11419 +4731 6 49.7048 27.2599 6.72622 -1.43928 22.3256 -10.7839 +4732 4 49.6686 26.3369 6.45132 -5.99645 4.70457 -4.8273 +4733 4 49.2845 27.8697 6.04945 8.54794 -27.7312 19.0533 +4734 6 39.7449 11.5776 10.1987 6.84991 -8.95817 -1.04181 +4735 4 40.3059 10.8428 9.86803 -8.86198 19.4731 1.33094 +4736 4 39.0907 11.7833 9.50723 6.52335 -1.56097 1.75374 +4737 6 17.4857 24.9907 35.5559 -11.6728 -0.232318 -1.23817 +4738 4 17.2359 24.7743 34.6481 -9.71541 0.96097 3.2925 +4739 4 18.4326 24.9281 35.5495 18.729 -4.76527 0.24637 +4740 6 45.0886 34.9858 31.8393 -13.7853 -2.59791 -12.3576 +4741 4 44.2542 35.4282 32.0247 4.31579 11.0194 10.5125 +4742 4 44.8031 34.4855 31.0733 13.3341 -13.9746 -4.20839 +4743 6 30.2109 9.89077 31.3202 8.39813 20.0527 10.0978 +4744 4 30.4343 10.7522 30.9233 -1.69236 -11.2354 5.34707 +4745 4 30.0976 10.0887 32.2697 2.61193 -8.5831 -6.90929 +4746 6 32.3748 9.22464 6.61109 37.8815 -39.2378 -50.8405 +4747 4 32.2118 8.68084 5.76454 4.57858 20.451 35.1159 +4748 4 31.5433 9.4233 6.96427 -45.6188 15.529 19.6617 +4749 6 9.26845 24.9782 35.9229 1.19564 -9.02769 -15.4958 +4750 4 8.9564 25.4582 35.1216 5.49795 -4.99978 19.1154 +4751 4 9.87718 25.5584 36.4061 -8.42028 -2.10732 -11.5846 +4752 6 40.3335 1.48296 18.8902 20.9136 0.652934 -58.3414 +4753 4 39.6207 1.94237 19.2768 -32.228 11.5513 31.9135 +4754 4 40.836 0.952532 19.4949 5.43911 -12.9068 21.333 +4755 6 5.27733 10.6166 30.4293 -4.37857 29.6514 35.8012 +4756 4 5.00531 11.4476 30.0112 -0.880507 -1.63534 -8.13264 +4757 4 5.35863 10.9185 31.3957 -0.759826 -20.4729 -25.7258 +4758 6 25.6655 11.6994 25.6535 -15.8411 -39.3949 6.40341 +4759 4 25.8392 12.448 26.1908 9.94197 23.9877 11.5846 +4760 4 25.8146 10.9427 26.2759 4.01869 23.17 -23.7809 +4761 6 21.9208 20.0736 29.783 -0.661059 -23.1285 25.9828 +4762 4 22.5528 19.9674 30.5279 -9.0028 12.6586 -11.845 +4763 4 21.4796 19.2024 29.7633 3.30396 8.80601 -15.8778 +4764 6 10.0031 19.9894 34.5062 10.0701 -18.9504 -1.84201 +4765 4 9.43917 20.4787 35.093 -9.85162 7.82768 6.06887 +4766 4 9.97528 19.0642 34.823 3.96148 11.1077 -9.79004 +4767 6 24.6395 10.3611 12.2013 10.4056 19.7725 40.7349 +4768 4 24.7062 9.53294 12.699 -2.91134 1.50973 -12.3578 +4769 4 25.0089 11.0108 12.8733 -15.5791 -20.8054 -25.2752 +4770 6 50.4386 28.2959 11.551 52.3964 -11.4141 -41.8896 +4771 4 51.2944 28.7096 11.1811 -37.3824 -15.4271 20.8858 +4772 4 50.1484 28.8694 12.238 -9.02874 19.1251 18.783 +4773 6 13.9255 27.6321 25.0575 -30.7043 9.27758 -16.9407 +4774 4 13.4685 27.961 25.8505 6.53671 1.50814 -8.33226 +4775 4 13.405 28.0084 24.2853 19.6442 -13.6277 24.9436 +4776 6 46.1675 18.6723 40.4127 -24.7255 0.52235 -5.51451 +4777 4 45.2163 18.6287 40.1471 17.8616 -3.70574 0.193046 +4778 4 46.2526 19.5549 40.792 -2.63441 -2.56699 -8.45512 +4779 6 32.4875 14.1744 27.1342 -20.1773 -0.115465 -0.458595 +4780 4 31.894 13.6021 27.6676 10.0212 10.5514 -7.27374 +4781 4 32.1329 15.0809 27.2203 4.74838 -8.22403 2.71507 +4782 6 14.0641 36.351 13.3878 -9.69625 43.6715 -7.48797 +4783 4 14.0645 37.3444 13.3555 12.262 -25.9465 20.9036 +4784 4 13.2835 36.2347 12.8457 -5.28255 -22.0231 -7.64651 +4785 6 1.89477 36.5899 21.9857 -12.7075 -7.68583 0.53673 +4786 4 1.75133 36.5712 22.9388 2.01013 -3.06644 8.01032 +4787 4 2.81569 36.8315 21.8421 3.36212 -1.19737 0.805445 +4788 6 25.2943 31.8607 39.7417 -2.48011 0.614033 34.0265 +4789 4 24.999 32.7283 39.4716 -5.73903 6.77443 -6.35095 +4790 4 25.461 31.9431 40.7124 0.191009 -4.33082 -23.8473 +4791 6 6.4797 22.0186 1.29894 -12.0535 -14.7769 -6.17691 +4792 4 5.53353 21.8063 1.36197 11.0348 5.26157 5.70773 +4793 4 6.5732 22.8347 0.80957 1.58971 11.8894 0.78955 +4794 6 27.6266 25.0275 4.69979 7.76412 30.8855 29.066 +4795 4 28.5017 25.4862 4.66738 -16.9061 -15.4428 -5.02391 +4796 4 27.2115 25.3905 5.52919 8.95609 -10.8934 -21.2922 +4797 6 21.6474 30.9429 41.2213 -14.674 16.9935 -31.5335 +4798 4 21.3077 30.3434 41.8509 -10.7705 -24.5884 29.0962 +4799 4 20.9035 30.9616 40.5667 22.5963 5.39714 5.21952 +4800 6 32.3503 18.8691 12.7728 -7.52429 -0.383917 -18.241 +4801 4 31.3918 18.9773 12.8161 6.27066 1.36054 6.85895 +4802 4 32.4619 18.5656 11.8564 12.6246 0.663961 8.91714 +4803 6 35.6352 19.4593 21.1461 -10.1734 29.4522 17.7801 +4804 4 35.3511 18.62 21.5049 -2.07097 -11.6796 -4.30053 +4805 4 34.9906 20.1214 21.5255 16.9121 -20.2959 -15.2058 +4806 6 27.6974 17.9478 34.0105 3.72497 22.7808 11.4532 +4807 4 28.1244 18.3695 33.2449 -3.6365 -3.33971 3.70746 +4808 4 28.0134 18.5196 34.7467 -3.33496 -14.4526 -11.1074 +4809 6 34.1722 39.0415 14.8025 -0.588556 -5.09353 50.87 +4810 4 33.8492 38.3378 14.2426 -9.69809 -4.78927 -2.35124 +4811 4 33.6075 39.0103 15.6476 14.9636 10.6202 -38.8415 +4812 6 28.5063 3.47722 33.8826 -13.8698 -21.2799 4.06498 +4813 4 27.871 4.20321 33.9085 6.20243 8.28698 -1.91661 +4814 4 29.4175 3.76621 33.9059 10.9167 16.0273 -3.84391 +4815 6 34.9231 32.1486 6.55347 -48.5451 -22.9266 3.43697 +4816 4 33.9921 31.9748 6.9467 49.872 11.9331 -17.2337 +4817 4 35.5478 32.1135 7.28146 1.17984 3.66225 6.53991 +4818 6 31.8923 6.87344 23.517 2.73099 13.3553 4.48118 +4819 4 32.4005 6.72509 22.7097 -0.163961 -9.68163 3.8586 +4820 4 32.2042 7.75277 23.812 -2.19309 -5.80853 -1.60196 +4821 6 18.8495 1.74691 0.846251 -10.8424 6.73855 -33.2301 +4822 4 18.128 2.12906 0.287715 7.30697 -5.37966 19.0723 +4823 4 19.1812 2.42034 1.43504 -3.90896 9.02122 12.2654 +4824 6 27.0029 18.9235 11.8738 61.7268 20.0146 -35.0636 +4825 4 27.2277 19.7644 11.4142 7.64396 -16.2258 9.71345 +4826 4 26.1059 19.0334 11.9849 -72.3018 -1.47246 20.779 +4827 6 43.8315 11.1413 18.4425 12.0955 7.77381 31.2403 +4828 4 43.582 10.9955 17.5403 1.6883 -14.8273 -19.2234 +4829 4 44.4878 10.475 18.7348 -4.89818 7.49251 -15.5557 +4830 6 33.4942 40.5585 37.6724 7.87983 -3.11064 16.6213 +4831 4 33.9456 40.2455 38.4765 5.57637 6.44045 -9.71494 +4832 4 32.6057 40.2384 37.8499 -11.5443 1.61602 -9.31227 +4833 6 15.6218 26.7049 39.4143 -33.8245 -53.4627 11.7102 +4834 4 15.4245 26.9754 40.2985 -0.693124 5.44593 20.3253 +4835 4 16.1216 27.3809 39.0562 36.6223 43.7441 -31.7418 +4836 6 4.38199 13.876 40.8778 6.07973 -11.0772 -3.70535 +4837 4 5.33347 13.6897 41.0138 -14.6737 -0.272428 -1.39073 +4838 4 4.02273 13.2235 40.2449 7.64869 11.7946 8.98025 +4839 6 20.1779 10.396 38.2135 -21.4206 4.43784 1.78325 +4840 4 20.3564 10.9148 37.4134 10.9013 -11.3706 0.559506 +4841 4 20.991 10.2443 38.6984 6.99273 1.77474 -1.94206 +4842 6 15.1578 19.2491 23.8705 6.70925 0.197906 -4.49513 +4843 4 15.3523 20.1614 24.134 -1.79925 -4.44488 8.10361 +4844 4 15.0598 19.3463 22.9079 -1.20619 -5.61783 14.9214 +4845 6 47.881 28.6148 15.8048 16.8356 22.7469 11.8397 +4846 4 48.0602 27.74 15.4965 -2.52866 -23.0751 -5.40804 +4847 4 48.6281 28.8091 16.402 -10.5906 -5.01786 -6.93826 +4848 6 29.925 30.905 18.9707 11.7406 3.33263 -1.10353 +4849 4 29.0879 30.4807 18.764 -8.84985 -7.33813 -1.92291 +4850 4 29.807 31.8375 18.7873 -6.04184 4.11832 2.37084 +4851 6 11.9324 35.8064 28.512 -27.4265 24.0258 -21.7564 +4852 4 12.5706 36.1347 29.1334 15.2736 -4.81493 21.8335 +4853 4 12.2236 34.9831 28.145 8.79196 -20.6768 -0.490374 +4854 6 29.967 37.8624 25.4885 4.59009 -4.14727 -0.313094 +4855 4 30.2605 37.0012 25.8228 -4.78695 -0.224547 -14.1967 +4856 4 30.4431 38.4647 26.0537 0.190265 15.5785 7.27405 +4857 6 52.6385 28.1101 32.2696 27.4129 -14.0906 14.429 +4858 4 52.1837 28.8064 31.8018 1.35463 13.918 -3.63194 +4859 4 53.5572 28.4115 32.4361 -8.8806 -0.527566 -10.0859 +4860 6 37.0194 40.0856 11.9811 12.8522 -14.0915 -8.99985 +4861 4 36.2698 40.6335 12.1547 -20.3135 9.86443 5.11387 +4862 4 37.3206 39.8255 12.8594 7.06858 1.59634 4.17732 +4863 6 16.6823 16.7862 36.5016 -40.0159 24.4695 -22.7659 +4864 4 15.9639 17.4464 36.7433 30.1481 -22.6997 -3.51596 +4865 4 16.709 16.8774 35.5181 2.88256 -1.64708 20.873 +4866 6 28.0056 4.17661 38.8341 -15.1907 4.44859 15.1459 +4867 4 28.8664 4.34511 39.2253 10.7528 -1.70638 -4.98709 +4868 4 28.1362 3.72531 37.9969 -2.54795 -6.06729 -7.91519 +4869 6 28.9121 0.2613 17.7196 11.2429 43.6022 -6.13696 +4870 4 28.206 0.913023 17.5432 1.57334 -10.0134 0.986336 +4871 4 28.5175 41.3357 17.883 -22.7122 -29.353 3.51833 +4872 6 22.9275 20.1119 26.272 10.3141 -17.1908 1.54721 +4873 4 23.597 20.0083 26.9758 -6.33812 5.26805 -6.32666 +4874 4 22.343 20.8217 26.5441 4.5912 8.26641 6.04785 +4875 6 49.4104 29.8887 13.4211 -27.0365 40.5227 7.20695 +4876 4 49.0994 30.824 13.2506 14.963 -27.7355 -0.582388 +4877 4 48.6865 29.5209 13.9525 8.18699 -4.12202 2.86767 +4878 6 2.45827 24.8307 7.29137 -22.8365 1.45709 37.207 +4879 4 2.32025 24.5445 8.23446 11.0976 11.5137 -22.649 +4880 4 1.77037 25.516 7.1857 7.09177 -11.7652 -6.70138 +4881 6 30.3948 26.4611 14.3404 -21.8067 20.3233 2.80707 +4882 4 31.1122 26.3224 14.9982 -12.4575 10.0222 -1.69757 +4883 4 29.8137 27.2743 14.5309 34.7851 -33.9666 2.2264 +4884 6 27.0321 32.5068 3.14827 -14.3662 17.1598 1.60641 +4885 4 26.4039 33.1156 3.62616 22.1531 -16.0826 -13.2832 +4886 4 27.3831 31.9163 3.82559 -1.71579 -4.01879 3.19031 +4887 6 34.2634 14.7959 1.27313 2.99828 -7.05923 -10.0889 +4888 4 35.1835 14.4352 1.19997 -20.4533 4.23129 -4.55267 +4889 4 33.713 14.3258 0.588346 24.9828 8.52884 21.9593 +4890 6 30.022 8.54163 1.32868 -10.2939 -13.069 16.6852 +4891 4 30.0052 9.45247 1.0409 -5.08902 11.4157 2.73646 +4892 4 29.2496 8.43498 1.92915 15.9692 5.13326 -10.6744 +4893 6 42.5647 11.5185 27.7103 -4.68909 6.08661 -3.61857 +4894 4 42.216 12.3928 27.8946 9.09127 8.642 -2.18095 +4895 4 41.8714 10.9656 28.0604 -6.00702 -16.6262 4.78299 +4896 6 52.461 39.5492 17.8365 12.2605 -26.0754 -32.0817 +4897 4 51.7553 39.7908 18.3861 -39.7898 9.50592 28.6027 +4898 4 53.1226 40.1801 18.0155 30.5873 23.5517 5.0779 +4899 6 33.2136 4.91918 31.6183 -6.56942 36.6821 16.923 +4900 4 32.9061 5.86322 31.5606 3.78329 -26.1329 5.01225 +4901 4 32.8884 4.48208 30.835 -2.61462 -3.20134 -11.4125 +4902 6 6.2936 16 18.7476 -12.5252 7.31014 22.9936 +4903 4 5.79227 16.5246 19.4216 24.8679 -4.64947 -16.2991 +4904 4 5.64136 15.3462 18.514 -6.08951 -9.62478 -9.34051 +4905 6 8.52033 14.5365 24.6875 -9.84601 3.26611 -2.01077 +4906 4 9.36791 14.3624 25.0978 6.86066 0.30113 1.47813 +4907 4 8.18366 13.6846 24.3866 1.77672 -1.96336 3.84573 +4908 6 22.6911 10.1297 32.1351 -27.5214 -52.5729 10.3709 +4909 4 22.3884 10.9899 32.3649 2.47289 32.4289 -2.22619 +4910 4 23.5203 10.1223 31.6812 20.4751 21.0076 -14.9216 +4911 6 11.292 2.12704 14.679 -26.9964 -14.1635 0.457424 +4912 4 10.3004 2.01295 14.5746 25.662 7.6895 -7.09692 +4913 4 11.7079 2.38272 13.8392 -0.157448 -3.91762 -7.39795 +4914 6 44.9096 15.591 36.2717 33.6405 -1.91298 -30.8875 +4915 4 45.0764 15.4828 35.303 -3.33411 7.1012 27.4883 +4916 4 43.99 15.446 36.3379 -31.2371 -2.78707 10.2167 +4917 6 9.72465 19.0179 31.2227 19.6005 -24.8416 -16.8371 +4918 4 10.5897 19.4265 31.3159 1.30764 -1.40065 3.11778 +4919 4 9.11252 19.5759 31.653 -23.8989 17.913 16.8503 +4920 6 51.9714 7.58847 16.6881 21.0297 -20.8952 -55.8985 +4921 4 52.6598 6.90966 16.567 -10.1825 8.15334 22.1112 +4922 4 51.6538 7.5728 15.7392 -8.87714 21.5211 34.751 +4923 6 31.4317 34.7753 36.422 -0.942044 -9.40807 -31.2122 +4924 4 31.7249 34.7672 37.3268 6.30465 10.9632 14.3566 +4925 4 31.2441 35.6593 36.0754 6.17504 10.5044 11.3925 +4926 6 4.22663 15.0937 15.3657 -12.9272 -11.1361 22.285 +4927 4 4.10058 14.8824 16.3208 1.18356 5.05287 -17.269 +4928 4 5.17453 15.1773 15.2713 12.4851 5.61025 -4.39011 +4929 6 47.7531 20.6767 28.0224 11.2198 -3.02063 -12.9376 +4930 4 47.6925 19.771 27.6598 -2.10862 13.919 9.51432 +4931 4 48.3916 21.1163 27.4231 -12.1395 -0.81062 10.3277 +4932 6 15.815 1.15165 24.4078 -58.142 17.9603 -16.0616 +4933 4 15.2825 0.557615 24.9446 12.6892 -15.3828 1.22604 +4934 4 15.0545 1.63036 23.9524 41.7436 -8.72437 9.7488 +4935 6 34.5811 39.7067 40.0776 25.1973 35.6425 -42.1699 +4936 4 34.2041 40.3093 40.7031 -18.6223 -6.05265 24.4589 +4937 4 34.3171 38.8242 40.1905 -21.7766 -38.3424 16.3885 +4938 6 20.1959 32.1778 34.4064 -21.1308 28.8301 22.4919 +4939 4 19.7756 32.8897 35.0113 13.9702 -37.934 -23.8567 +4940 4 21.1121 32.1056 34.6926 -2.59197 2.17732 9.39736 +4941 6 19.2966 38.5284 11.8437 26.0429 16.0259 -0.414132 +4942 4 19.2747 37.5954 11.9891 -3.91225 -17.7096 3.53088 +4943 4 20.0654 38.8356 12.3915 -17.5462 -2.40166 -9.14392 +4944 6 6.53181 13.5016 26.8314 -26.032 48.4544 -13.2533 +4945 4 5.96734 14.0602 26.204 31.1233 -23.713 24.7575 +4946 4 6.50803 12.6321 26.4707 -0.853216 -24.803 -10.5103 +4947 6 23.5899 31.5666 33.3383 5.98922 -6.50638 -9.93577 +4948 4 23.0479 31.6137 34.1308 1.15429 -4.79335 1.92272 +4949 4 23.6428 30.629 33.0606 -7.31668 7.17491 0.194963 +4950 6 41.0566 31.9249 16.2102 56.5158 -30.8904 -22.4873 +4951 4 41.9283 32.0344 16.659 -25.525 5.07155 -0.752829 +4952 4 41.3339 31.2779 15.4895 -19.0587 21.5349 12.1439 +4953 6 31.7523 18.8667 19.3593 3.35741 25.414 0.712525 +4954 4 32.0759 19.7269 19.7383 -8.81617 -22.0304 -12.3923 +4955 4 31.2718 18.4298 20.0739 7.05067 -2.94537 3.38628 +4956 6 10.4941 4.11052 19.3414 6.42456 29.4713 -33.6332 +4957 4 9.72315 4.57262 18.9428 7.32966 -14.5804 7.11 +4958 4 11.2095 4.33965 18.6811 -15.5987 -11.1936 33.5314 +4959 6 1.36933 32.4682 19.2841 21.0988 -14.4161 24.2075 +4960 4 2.01529 31.7231 19.2122 -13.2253 9.85044 -10.2965 +4961 4 1.01532 32.721 18.4367 5.36339 -4.1954 -20.4987 +4962 6 42.8687 16.8583 24.9978 45.6636 -43.4462 -50.5941 +4963 4 42.5079 17.7172 24.9824 -17.3855 32.283 0.331695 +4964 4 43.4322 16.7911 24.1362 -30.0172 8.55702 44.8961 +4965 6 45.317 19.181 4.10785 3.8422 34.8536 -4.15721 +4966 4 46.019 19.8398 3.89275 -2.03222 -14.2005 10.5278 +4967 4 44.6424 19.7199 4.5744 3.59127 -10.0852 -3.22755 +4968 6 29.1417 19.8939 35.7514 6.11075 -32.58 -16.2332 +4969 4 28.6926 20.3067 36.4515 -23.9686 13.1333 31.3988 +4970 4 29.2427 20.5957 35.1143 7.28783 5.32225 -12.4577 +4971 6 31.9564 21.8498 19.6592 2.82401 14.2352 -0.350828 +4972 4 32.7548 21.9543 19.0677 -31.5105 -7.28354 24.2009 +4973 4 31.6217 22.7614 19.848 10.5207 -20.3739 -6.13763 +4974 6 39.1981 8.2717 18.8284 -32.9061 14.1933 0.428726 +4975 4 38.9624 7.35629 18.6463 1.07118 -6.83808 -1.96228 +4976 4 38.3348 8.76709 18.6863 31.0345 -14.9445 1.78619 +4977 6 33.2818 13.2775 41.2684 -13.2208 -33.3764 1.31987 +4978 4 32.393 13.5626 41.0006 -3.83673 2.91025 7.56978 +4979 4 33.1808 12.3338 41.5845 5.22215 22.8712 -2.04361 +4980 6 5.9413 29.5498 35.797 -32.456 -34.3071 -6.72563 +4981 4 6.35963 30.284 36.1739 22.861 33.0715 10.0739 +4982 4 6.49565 29.1835 35.1072 8.32337 2.91553 -5.44074 +4983 6 13.0321 34.2086 31.915 -24.835 -40.2345 36.8573 +4984 4 13.0272 33.4084 31.376 1.88868 -0.760633 -7.07942 +4985 4 12.5489 33.9041 32.737 18.271 18.5714 -18.1292 +4986 6 33.9591 21.7903 18.011 18.8454 -21.734 -8.71067 +4987 4 34.7458 21.1933 18.012 -16.5142 3.18134 2.17277 +4988 4 34.2934 22.6573 17.8484 16.983 20.6817 -10.003 +4989 6 35.9748 41.3385 18.1559 -11.3515 0.0380054 -35.3696 +4990 4 35.8093 41.5204 17.1769 9.12346 -12.4659 34.6458 +4991 4 36.6045 0.098617 18.3947 7.40652 10.177 5.52403 +4992 6 34.8515 37.6574 30.5934 11.7527 -35.7483 27.3047 +4993 4 35.1492 36.8608 30.1169 2.57906 15.2804 -10.7791 +4994 4 34.9371 37.33 31.5271 -8.43612 19.6249 -16.9201 +4995 6 26.002 34.4146 4.67279 -8.48904 3.78898 9.19231 +4996 4 25.4415 34.5852 5.42871 -16.9308 -4.98482 2.97274 +4997 4 26.7915 34.86 4.9592 18.7282 4.65341 -5.76761 +4998 6 19.0552 33.5605 1.32358 6.49267 31.5074 -37.6332 +4999 4 19.8139 33.1288 1.70335 8.38847 -12.1483 9.88993 +5000 4 19.4402 34.1326 0.589952 -11.7405 -21.1797 25.0755 +5001 6 25.2648 8.23393 8.59155 9.31521 -3.65292 19.8467 +5002 4 25.4875 8.13778 9.5404 -3.07709 1.08931 -10.3145 +5003 4 25.4314 9.16241 8.38927 -1.28134 -0.00667841 -6.07783 +5004 6 12.8479 19.6935 13.0483 24.3757 5.37981 -4.8091 +5005 4 11.9603 19.9957 12.9501 -28.6845 1.86907 1.18076 +5006 4 13.3523 20.516 12.8959 -4.89806 -16.374 -0.906345 +5007 6 53.3502 11.4299 5.80806 17.1624 -7.42289 17.7098 +5008 4 53.8461 12.0471 6.36061 9.49207 -4.93163 0.0376 +5009 4 52.6392 11.9481 5.49246 -25.6427 10.4986 -14.7278 +5010 6 9.84876 16.0411 31.2026 18.9205 20.8399 7.27663 +5011 4 9.06508 15.7062 30.7868 -18.8641 -2.54228 -13.3824 +5012 4 9.84527 17.0253 31.1624 -7.05614 -14.0763 0.861631 +5013 6 25.427 20.2931 3.30062 11.4464 23.222 26.9187 +5014 4 25.5454 20.7694 4.15249 -9.33169 -17.4988 -10.5652 +5015 4 25.6323 21.0333 2.7154 -3.32412 -15.1122 -12.6987 +5016 6 20.7611 8.20749 15.6389 12.285 -44.7943 -30.6071 +5017 4 20.4521 8.55687 16.4556 -20.4937 3.03897 24.5457 +5018 4 20.4185 7.27697 15.5079 3.31214 29.403 13.2982 +5019 6 37.6491 8.60321 9.97383 13.4411 2.14626 39.4708 +5020 4 37.9762 7.71523 10.2023 -7.3296 7.95364 -3.74733 +5021 4 37.281 8.55077 9.10696 -2.37522 -5.79058 -16.8845 +5022 6 50.6587 4.51935 24.2622 -13.5896 -19.0591 8.29097 +5023 4 49.9232 3.87067 24.2726 8.09814 12.5004 -4.89174 +5024 4 51.4381 3.99879 24.4754 4.23299 2.4676 7.18675 +5025 6 20.1738 24.8175 34.9087 -20.6162 39.8894 -22.5586 +5026 4 19.8889 25.4664 34.1955 11.6566 -19.5752 19.2833 +5027 4 20.4138 24.0094 34.4666 -0.241841 -16.354 -5.00311 +5028 6 30.5812 22.5243 11.2258 -36.8716 21.596 38.6978 +5029 4 31.1688 21.9929 10.7494 35.9784 -15.9007 -22.5785 +5030 4 31.0799 23.2498 11.6175 0.71333 3.79074 -7.65826 +5031 6 17.3246 40.781 8.03002 -31.7256 21.6985 11.3561 +5032 4 17.3609 40.073 8.69249 8.70624 -3.14378 -12.3263 +5033 4 18.1517 40.9293 7.58873 21.0517 -16.9909 -7.06703 +5034 6 23.9551 41.0422 26.0635 49.9815 4.82526 35.6353 +5035 4 24.3667 40.5978 25.3173 -4.54613 -3.84774 -13.2149 +5036 4 23.0402 41.1884 25.9461 -38.539 -4.36769 -14.447 +5037 6 9.79432 25.5848 27.2203 6.65484 -20.1236 -27.319 +5038 4 10.0774 24.9678 26.4912 -4.54744 21.2611 22.5851 +5039 4 10.2742 25.3181 28.0139 -2.97183 -5.43805 2.20583 +5040 6 35.2559 29.8148 24.7567 4.66903 26.9266 -5.93859 +5041 4 34.3843 29.755 24.359 -8.51564 -12.4096 -2.57191 +5042 4 35.4992 30.7322 24.5163 3.09853 -9.53322 8.65044 +5043 6 2.14554 4.24448 10.5593 -22.2482 14.7122 10.1934 +5044 4 1.71214 4.34677 11.4486 21.0071 -10.277 -13.7719 +5045 4 1.55235 4.73342 9.96914 3.10164 -3.012 2.95666 +5046 6 43.1737 3.93442 23.504 -19.8173 -22.9925 0.828755 +5047 4 43.8868 4.03822 22.8829 13.7397 8.75634 -8.56433 +5048 4 42.5624 3.30318 23.0634 7.12322 11.7882 3.68849 +5049 6 18.8936 22.6308 2.43475 37.4693 -11.6119 5.39147 +5050 4 19.8359 22.2985 2.41568 -31.8063 3.38645 -2.45846 +5051 4 18.7431 22.7947 3.37318 -4.67781 1.83629 -1.28906 +5052 6 20.5039 18.9394 41.5502 -45.0653 -1.00263 50.2155 +5053 4 20.0478 18.6838 0.506021 30.3651 -1.16827 -32.2456 +5054 4 19.9073 19.6506 41.2865 12.7012 -1.26976 -15.3796 +5055 6 26.407 7.54687 29.1121 1.4357 2.47637 1.41449 +5056 4 25.6724 7.10479 28.6297 19.9382 8.96422 9.98625 +5057 4 27.0918 7.77745 28.4582 -11.2115 -7.41118 6.83701 +5058 6 25.6474 35.5684 33.7551 28.3954 -27.4775 -24.9773 +5059 4 26.3573 36.1942 33.5448 -9.56627 7.56335 10.8035 +5060 4 25.9974 34.7724 33.2466 -29.6941 19.0168 23.1671 +5061 6 24.829 0.49304 8.41898 49.9168 25.8876 59 +5062 4 25.5758 0.370102 9.1289 -47.1903 5.46774 -40.7742 +5063 4 24.7798 41.5674 8.0141 -4.73142 -31.3088 -22.2887 +5064 6 17.0191 17.3177 3.44507 -46.3903 19.7373 51.2207 +5065 4 16.2469 17.9517 3.64762 33.8447 -23.651 -21.8207 +5066 4 17.1185 16.9245 4.35427 5.98982 5.76213 -27.3591 +5067 6 40.1787 32.0965 19.3495 -2.04197 44.459 1.39821 +5068 4 39.7315 31.3261 19.6693 2.08081 -28.8107 0.337304 +5069 4 40.9568 31.869 18.8472 6.84111 -19.9226 -1.15348 +5070 6 23.382 26.6945 6.30636 26.5913 52.1271 15.5788 +5071 4 24.0556 27.4456 6.44648 -17.1373 -33.2326 -1.34025 +5072 4 22.7142 27.1153 5.75328 -6.08389 -4.52619 -7.61988 +5073 6 28.6524 28.5085 1.41248 40.8971 -13.4399 -11.1281 +5074 4 28.8916 29.4207 1.30452 -22.1266 20.7664 -4.28256 +5075 4 29.5558 28.1704 1.18501 -32.1523 -8.03877 13.3744 +5076 6 12.0456 6.33448 14.0345 -15.8903 -34.4 -29.7535 +5077 4 11.2902 6.05291 13.4483 16.0844 18.9407 21.6686 +5078 4 12.7823 5.99392 13.4906 5.33453 16.7776 14.1371 +5079 6 20.1258 33.7078 32.0959 -18.1893 1.56867 -4.93457 +5080 4 20.1945 33.0222 32.7471 -6.29187 -8.74149 18.477 +5081 4 21.0272 33.8529 31.8657 20.6776 7.89431 -10.0095 +5082 6 12.0665 33.3691 34.5458 -17.2285 -56.0193 -22.1145 +5083 4 11.5086 33.8793 35.1106 -7.76206 16.4549 16.9315 +5084 4 11.5605 32.4987 34.4127 27.4292 33.0374 0.608769 +5085 6 6.00658 22.2666 25.0532 -19.3255 -5.39958 94.237 +5086 4 5.834 22.4197 24.1868 -9.01045 11.6196 -89.8037 +5087 4 5.17345 22.6031 25.4913 31.6285 -9.76338 -3.83253 +5088 6 28.8848 9.49767 11.035 16.7623 9.63116 22.4077 +5089 4 29.0495 10.2086 11.6768 10.1151 -22.3542 -11.392 +5090 4 28.083 9.83925 10.6889 -25.6685 -5.48517 -25.0151 +5091 6 25.9808 31.1499 24.8669 6.22835 -24.9986 7.12483 +5092 4 26.2942 31.9621 24.5011 4.31737 18.7644 -10.9339 +5093 4 26.6597 30.4768 24.6157 -18.0541 8.02771 8.13926 +5094 6 17.4051 22.6403 26.9653 -7.75883 36.9734 2.0054 +5095 4 17.2144 23.5004 27.4753 3.96627 -41.4428 -18.3441 +5096 4 17.5261 21.9375 27.6083 1.93016 -8.19761 6.25563 +5097 6 30.9714 17.6252 1.64088 21.0154 14.9482 37.3685 +5098 4 30.2059 17.6112 1.0839 -20.4324 5.80492 -14.3468 +5099 4 30.9516 18.4373 2.23396 3.22156 -25.7853 -22.8165 +5100 6 35.2764 9.72503 11.2414 -18.3895 -2.76749 -51.624 +5101 4 34.6551 9.56245 10.4589 20.7383 2.80865 37.1903 +5102 4 36.1302 9.43155 10.8742 2.68762 -2.05229 10.7544 +5103 6 12.0172 10.802 4.27563 -38.9121 -6.07101 -4.90761 +5104 4 11.4313 10.6374 5.04504 13.8247 1.49432 -7.40831 +5105 4 11.4074 10.5604 3.53263 22.811 5.33779 9.30002 +5106 6 52.9577 23.1313 7.67787 -9.3269 3.09364 -7.79077 +5107 4 53.8153 23.0871 7.22609 1.51949 2.98805 -1.25247 +5108 4 52.6879 24.0607 7.78743 10.5919 -6.87524 0.0783357 +5109 6 27.3762 5.80009 23.1013 37.771 37.8703 25.2466 +5110 4 28.2178 5.56094 23.5856 -32.2451 -1.57897 -13.9899 +5111 4 27.4704 6.79781 23.0764 -15.1432 -38.3322 -6.34326 +5112 6 22.7771 37.7063 15.5287 -6.89324 -10.2053 44.7861 +5113 4 22.8198 37.7465 14.5962 3.81902 5.91484 -35.4551 +5114 4 23.2903 36.9427 15.8415 -1.83068 2.7653 -4.67104 +5115 6 30.583 30.1381 39.7472 11.9278 5.78959 4.89923 +5116 4 30.1399 29.6129 39.0656 -4.27402 4.25284 -2.63349 +5117 4 30.6547 31.067 39.4612 -8.3831 -13.7724 -7.9353 +5118 6 26.5154 14.8633 29.9609 11.0831 -12.5589 -33.9006 +5119 4 25.6935 15.2477 30.2118 -18.1143 15.4408 19.147 +5120 4 27.1376 14.9035 30.6723 6.99544 5.71887 23.1856 +5121 6 9.52617 19.5446 37.4141 -27.8096 33.0225 -3.94279 +5122 4 8.56344 19.6819 37.5998 22.5694 -19.9005 4.13551 +5123 4 9.71087 20.3892 36.9619 8.68778 -16.8671 10.038 +5124 6 0.93064 14.8656 2.69338 -45.7679 -11.5139 71.6593 +5125 4 1.44105 15.217 2.01526 37.3122 25.2366 -40.5783 +5126 4 0.982855 15.4275 3.5214 11.2099 -15.0526 -29.9277 +5127 6 46.4291 27.1302 41.5927 44.8021 -5.11347 -18.4756 +5128 4 47.4269 27.1857 41.3316 -52.8753 -1.56841 10.8767 +5129 4 46.0453 26.5632 40.9031 3.09365 7.20255 7.14326 +5130 6 47.6703 23.0461 21.3817 14.1329 62.5249 18.4178 +5131 4 46.9615 23.2467 20.7836 -14.1781 -2.67912 -10.5965 +5132 4 47.8255 22.1376 21.4096 0.736735 -54.6337 -3.62162 +5133 6 39.861 22.2186 3.09273 14.3751 -13.6386 -17.8056 +5134 4 38.9812 22.2192 3.47284 -7.54245 -0.786418 6.90323 +5135 4 40.0217 21.2868 2.78929 -10.5756 29.8648 14.1337 +5136 6 14.9857 14.9315 33.4628 8.45923 30.4043 17.83 +5137 4 15.3946 15.8263 33.6275 -11.7248 -28.7506 -9.93609 +5138 4 14.5839 14.7058 34.318 1.67348 -1.86342 -8.89677 +5139 6 27.3225 11.4951 31.9326 -53.5602 -46.3542 13.457 +5140 4 26.8632 12.0627 32.5566 10.8872 8.4751 3.08438 +5141 4 28.1269 11.8297 31.6518 53.6341 36.944 -15.9306 +5142 6 36.7606 7.97817 7.63938 -5.6216 -14.483 -15.6739 +5143 4 35.961 7.43887 7.80711 8.78578 3.79539 -7.6162 +5144 4 37.414 7.37034 7.2323 -6.45073 3.96969 3.37374 +5145 6 49.4351 9.64395 18.2091 29.626 55.2849 10.866 +5146 4 50.1121 10.1978 17.7651 -9.80365 -29.4086 -13.348 +5147 4 49.2806 10.2909 18.9191 -22.4891 -21.6225 2.73598 +5148 6 27.0558 33.8708 10.7695 -35.2964 21.4972 9.63291 +5149 4 27.0077 33.3399 10.0051 13.5655 -23.8621 -34.587 +5150 4 26.1863 34.3133 10.6733 10.9844 1.63438 18.9088 +5151 6 11.1931 37.467 6.82672 4.88099 -16.6436 19.1561 +5152 4 10.8369 38.341 6.72067 -6.30082 13.8936 -5.38019 +5153 4 12.1372 37.6177 6.93955 5.33816 -5.06614 -4.03667 +5154 6 19.2682 19.4041 21.904 -23.2853 8.1035 46.9014 +5155 4 18.5523 19.4276 21.2977 -21.2798 -5.04156 -20.5384 +5156 4 20.0545 19.4439 21.4012 35.6905 -5.22778 -21.4405 +5157 6 54.5004 2.91828 22.5705 32.5661 -1.01917 48.733 +5158 4 54.2618 3.02388 21.6728 -2.16971 10.501 -40.9175 +5159 4 0.435524 3.25313 22.7695 -30.9494 -6.38648 -13.13 +5160 6 45.0599 10.868 24.2364 14.5135 -18.2796 4.13426 +5161 4 44.3635 11.4663 23.9664 0.226806 13.7258 12.1538 +5162 4 45.5813 11.1999 25.0017 -10.9868 0.331296 -15.4884 +5163 6 14.3917 34.4176 24.7766 -9.76404 -18.453 -6.38428 +5164 4 14.7761 35.2693 24.9957 4.99605 2.44674 1.2141 +5165 4 14.8449 34.0832 23.9904 0.575187 7.45256 -7.27956 +5166 6 50.5869 17.5623 4.30497 19.1488 -58.6727 24.3661 +5167 4 51.3501 17.8958 4.78847 0.670503 12.5806 -1.04554 +5168 4 50.1422 18.2474 3.88142 -19.7161 48.0777 -23.3625 +5169 6 14.9242 33.337 34.1076 -18.6172 33.5363 80.554 +5170 4 15.0808 32.9083 33.3321 11.226 -38.5345 -73.3592 +5171 4 14.0723 33.0217 34.4665 7.96171 10.4343 -9.42002 +5172 6 20.8631 33.5747 38.9135 21.2953 11.2024 -25.7312 +5173 4 20.865 34.0752 39.7143 -3.94121 7.45437 24.6588 +5174 4 20.36 32.7884 39.0656 -12.436 -21.6406 1.81461 +5175 6 7.7707 4.74963 26.7362 26.5342 -10.6541 19.1955 +5176 4 7.23261 4.91898 27.5026 -6.83786 10.9421 8.37469 +5177 4 7.15089 4.73593 26.0203 -3.95236 1.60233 -15.9617 +5178 6 9.2875 21.4887 22.2941 45.0197 -19.5209 20.7118 +5179 4 8.6739 21.9912 21.7696 -4.21454 15.1903 -23.2464 +5180 4 10.2572 21.6206 22.0058 -46.5259 5.6334 -2.177 +5181 6 20.5439 38.2154 8.85856 -11.8412 3.64647 49.7312 +5182 4 20.3505 38.5634 9.79035 9.75602 -4.66312 -40.2998 +5183 4 20.2844 37.2891 8.95048 10.2824 2.6457 -7.05014 +5184 6 30.1005 39.0839 30.7484 -12.1958 38.1552 23.9792 +5185 4 30.3724 39.9578 31.2326 -12.541 -45.9124 -25.2432 +5186 4 29.1103 39.003 30.8437 30.6219 6.07536 -1.13857 +5187 6 16.0462 22.036 24.5064 2.37861 -9.55962 -5.99251 +5188 4 16.6334 21.9741 23.7207 6.17482 7.89117 19.2285 +5189 4 16.5569 22.3155 25.2979 1.4399 -2.17025 -8.02685 +5190 6 5.74172 29.2061 14.4603 -14.7312 11.1013 -1.58992 +5191 4 6.41865 28.6839 14.8489 24.8954 -16.4528 0.429681 +5192 4 5.37542 29.618 15.2515 -13.4536 5.99623 -6.25212 +5193 6 28.0689 3.08071 25.2267 -3.20814 35.3244 14.901 +5194 4 28.6407 3.76435 24.8336 -2.36389 -14.401 -4.10269 +5195 4 27.6795 3.6106 25.9691 7.41152 -23.0621 -10.2478 +5196 6 45.9381 29.3111 31.4283 -35.5447 25.9568 9.82539 +5197 4 45.677 28.707 30.7493 2.31008 -18.1922 -21.3643 +5198 4 45.1265 29.9079 31.4744 34.4717 -15.8255 11.1052 +5199 6 11.2229 22.8376 36.7897 -1.27591 2.9175 -5.69903 +5200 4 10.6623 23.4314 36.25 10.4728 -5.78036 -0.0474996 +5201 4 12.0147 22.5841 36.2713 -9.37786 4.28983 5.66853 +5202 6 18.9444 40.1485 39.92 -15.471 -8.01044 2.33142 +5203 4 19.1439 39.1941 39.9507 -1.34087 5.25319 4.4419 +5204 4 18.8847 40.4877 40.8271 3.43659 -8.21326 1.76593 +5205 6 23.5503 26.0803 21.2869 1.98517 -8.46863 16.2364 +5206 4 22.847 26.649 20.9475 -0.393515 -5.32061 4.06564 +5207 4 23.2913 25.6403 22.1336 -2.29953 13.2014 -21.5927 +5208 6 16.8518 5.38834 15.8565 -25.8193 5.07215 -6.0744 +5209 4 16.3979 5.3834 15.0179 8.08064 -16.6857 -11.3384 +5210 4 16.3642 6.13153 16.2159 17.5374 8.90145 23.838 +5211 6 12.0293 26.6115 15.0052 48.8575 28.3431 -20.5386 +5212 4 11.753 25.9113 15.557 -22.1508 -25.2102 16.954 +5213 4 11.3677 26.9943 14.4309 -20.7091 -9.23994 -0.184726 +5214 6 14.3404 41.4231 2.37222 21.8802 31.2536 -15.2067 +5215 4 13.6639 41.0433 2.88545 -29.1815 -25.4177 23.2655 +5216 4 14.3137 0.446574 2.65591 6.04323 -12.5169 -2.89291 +5217 6 50.3994 35.8721 9.32148 7.74023 -5.00078 -0.0244409 +5218 4 50.7985 35.7097 8.44539 1.7624 12.9821 5.72804 +5219 4 50.9327 36.5364 9.8137 -9.76519 -8.88391 -14.7497 +5220 6 11.3732 22.6657 26.8674 13.5542 4.36995 9.37334 +5221 4 12.2226 22.4007 26.49 -3.86507 -2.48494 3.34128 +5222 4 10.7274 22.4174 26.2153 -14.8849 -5.84603 -9.40936 +5223 6 8.44501 34.5567 21.2657 -4.1178 -59.9386 7.63204 +5224 4 8.06567 35.1301 21.9247 -8.42944 2.78434 16.8569 +5225 4 8.10966 33.58 21.4462 13.1168 58.8803 -11.2866 +5226 6 9.4289 8.66253 24.4817 -31.3326 14.2813 -20.5935 +5227 4 8.45611 8.64572 24.2655 24.8039 10.7682 6.42659 +5228 4 9.52915 9.21836 25.2644 -0.461641 7.68001 5.20174 +5229 6 32.603 22.3274 34.5057 1.1064 -2.38466 -37.2003 +5230 4 32.4525 23.1707 34.0368 4.85154 -2.46017 7.68642 +5231 4 32.8396 22.5701 35.3818 7.58742 14.9461 32.9529 +5232 6 26.736 26.1837 7.12165 10.4716 16.8024 -17.1295 +5233 4 25.9537 25.8031 7.51207 -7.84415 -15.2109 12.7352 +5234 4 26.4604 27.1054 6.93432 8.77765 -19.2484 4.4957 +5235 6 34.0014 11.9295 3.96807 -3.56186 4.82634 5.33773 +5236 4 33.6494 11.5631 4.78494 7.3544 2.33703 4.85457 +5237 4 33.8594 12.8842 4.06904 0.478869 -2.08104 -5.13073 +5238 6 21.473 20.924 37.1992 5.8677 19.4674 12.3893 +5239 4 22.3242 21.3752 37.157 2.6693 1.87465 3.04951 +5240 4 21.708 20.0203 37.0255 -6.20277 -25.1527 -1.47337 +5241 6 18.4792 41.0219 0.672743 -35.2491 -25.3697 -26.4792 +5242 4 17.5363 41.1592 0.451811 6.2729 -6.09178 6.10687 +5243 4 18.7532 41.8934 0.847545 18.5165 37.9853 8.81983 +5244 6 41.3458 41.7141 25.1818 17.8335 14.8146 -1.57438 +5245 4 40.8444 40.9381 25.3951 -6.7286 -20.9895 5.67055 +5246 4 41.5773 41.6158 24.2546 -2.61686 2.51709 -2.2804 +5247 6 27.6337 28.128 3.93443 68.2433 49.922 -72.4808 +5248 4 27.747 28.0641 2.90056 -5.60951 6.59214 55.905 +5249 4 26.974 27.5707 4.19301 -60.7891 -51.6503 16.466 +5250 6 18.2766 10.5218 31.4985 31.6557 -13.945 -4.11948 +5251 4 17.4661 10.038 31.5755 -21.8827 2.32902 1.26527 +5252 4 18.1351 11.463 31.4681 -8.30794 8.79106 3.21692 +5253 6 11.3047 37.9513 14.7719 14.2766 22.5792 8.51892 +5254 4 10.8196 37.2524 14.3384 -3.55752 -10.2024 4.33151 +5255 4 11.8722 37.607 15.4977 -19.1201 -2.12261 -16.4117 +5256 6 0.810718 18.1323 27.5767 30.9572 19.3393 -0.702274 +5257 4 0.190255 17.4711 27.3024 -13.6082 -17.9307 4.12615 +5258 4 1.6652 17.6816 27.7433 -15.3641 2.36995 -0.952151 +5259 6 36.7957 10.7342 20.2882 16.9593 17.0847 7.18326 +5260 4 36.2525 10.0089 20.0111 -13.8544 -11.0907 -5.31633 +5261 4 36.5766 10.8708 21.2175 -0.466777 -2.92115 4.06643 +5262 6 47.4269 25.5204 8.035 -8.77625 7.04012 -26.0141 +5263 4 47.2351 25.672 7.07342 16.0738 -5.10236 26.6147 +5264 4 46.6031 25.1946 8.38488 -7.38433 -0.0309169 8.21918 +5265 6 13.9121 35.1279 15.9963 57.6206 21.904 15.8158 +5266 4 13.18 34.6338 16.2776 -41.6081 -30.4219 4.97616 +5267 4 13.8612 35.4714 15.1124 -11.7278 3.29634 -19.5683 +5268 6 29.56 35.3617 16.1847 -46.2751 8.28104 -14.7299 +5269 4 30.2098 34.9035 16.6971 16.3841 -9.08849 15.1595 +5270 4 28.6495 34.9755 16.3324 34.0842 8.73794 -6.93478 +5271 6 29.4892 25.8842 32.4194 -24.256 -10.4352 -29.1805 +5272 4 28.8256 25.7516 33.0892 -1.91161 2.59937 23.0953 +5273 4 29.0388 25.4531 31.6468 24.6149 5.96309 7.68736 +5274 6 24.1242 2.12171 25.4449 33.2745 25.8541 -21.7468 +5275 4 24.4973 2.84525 24.8288 -6.14236 -31.0627 26.9036 +5276 4 24.7925 1.39916 25.5361 -16.9688 12.032 -10.1501 +5277 6 4.54733 34.4389 19.1463 -35.302 -7.10976 -3.39284 +5278 4 4.35486 34.5879 18.2161 16.9971 0.874352 -7.12679 +5279 4 3.63202 34.4395 19.5005 25.743 -3.14875 11.9651 +5280 6 10.1206 17.2361 14.3164 8.36708 -29.6599 -28.3251 +5281 4 10.306 17.5039 15.1955 -0.106022 16.7729 24.4966 +5282 4 9.5035 17.8022 13.8616 -7.59249 10.3925 2.01091 +5283 6 21.4437 41.7724 34.6698 -12.6382 -8.67476 11.1219 +5284 4 21.3209 41.1297 35.367 19.1323 -10.7035 11.8578 +5285 4 20.52 0.052046 34.4982 -0.738196 4.11389 -17.598 +5286 6 36.1618 24.1149 12.6039 -38.5184 -29.276 -18.6614 +5287 4 35.5274 23.7914 13.2897 25.4622 4.78071 -2.2183 +5288 4 35.751 23.7447 11.7708 17.6549 15.9976 15.8112 +5289 6 49.5813 18.6026 19.9424 19.3655 4.31785 -3.79274 +5290 4 50.05 19.3681 19.5461 -11.4841 -9.87428 2.01803 +5291 4 50.2881 17.9408 20.0283 -8.44417 3.53865 1.64593 +5292 6 1.24663 7.05846 14.4912 39.2605 -25.8072 -27.0237 +5293 4 1.83321 6.85564 13.6734 -27.5618 7.792 37.3713 +5294 4 1.40902 6.33035 15.1313 0.69425 14.6008 -10.3474 +5295 6 12.7431 22.7725 31.2519 -28.0711 -22.2846 -24.537 +5296 4 12.731 22.0484 30.5842 -1.03989 14.4355 17.1556 +5297 4 13.6361 23.0601 31.2889 29.0982 7.61123 0.941905 +5298 6 8.17623 18.6217 27.8167 28.4831 -7.95646 -20.137 +5299 4 8.40342 17.6669 27.8028 -7.19499 14.8132 8.92302 +5300 4 8.90402 18.9943 27.2753 -13.5351 -1.9306 8.34595 +5301 6 52.1398 28.0368 15.3061 -5.99984 -2.63203 -6.56281 +5302 4 52.212 27.4921 14.5152 3.50742 -7.1981 5.43712 +5303 4 52.1344 28.9249 14.9274 -1.52971 -5.17654 6.68842 +5304 6 52.6974 21.8977 10.081 -19.9085 6.90605 5.3514 +5305 4 53.3388 22.3376 10.626 19.2735 6.64212 5.60719 +5306 4 52.8023 22.3165 9.21858 0.448532 -1.39229 -3.54893 +5307 6 22.3312 5.79987 2.67028 14.2956 -6.96789 22.7666 +5308 4 22.4342 5.66665 3.62826 -7.95027 2.50856 -4.24886 +5309 4 22.7763 5.02131 2.34757 -2.68692 -18.1597 -17.0707 +5310 6 15.4178 16.2178 21.8878 29.1139 16.3559 -34.9346 +5311 4 14.4763 16.1482 22.0206 -17.0561 3.51129 1.66656 +5312 4 15.5967 16.6295 20.979 -16.1676 -12.6325 35.129 +5313 6 28.6996 41.2944 33.8986 -0.299799 0.972013 4.01662 +5314 4 28.6528 40.5712 34.5346 5.69191 -6.81028 -1.89437 +5315 4 27.7925 41.4039 33.5788 7.00998 2.71453 4.16387 +5316 6 9.0271 31.2603 18.2166 -24.0632 3.5617 9.69965 +5317 4 9.00312 32.2249 18.3215 -0.833429 -0.795431 1.49639 +5318 4 8.39564 30.8695 18.8792 23.5138 4.17381 -14.686 +5319 6 20.5401 20.4009 18.1765 -9.82111 13.5354 -7.0052 +5320 4 21.0961 20.6619 18.9088 6.00228 -1.57494 14.3732 +5321 4 19.8969 21.1451 18.1138 9.42471 -20.4088 -2.28899 +5322 6 53.9632 14.7108 37.8185 38.9936 -13.777 37.4998 +5323 4 53.5065 15.4999 38.0588 -19.2143 21.2037 -5.62994 +5324 4 53.6553 14.2856 37.0504 -18.643 -5.89619 -29.3657 +5325 6 28.9005 15.3805 18.8553 43.4355 2.75939 -10.7082 +5326 4 29.8744 15.2601 18.5577 -43.1698 -4.30042 15.6378 +5327 4 28.8821 15.3937 19.8257 1.95554 -2.72042 -0.550014 +5328 6 2.00757 25.8231 18.9102 1.56834 13.1457 16.4238 +5329 4 2.16994 26.6099 18.3718 5.10623 3.14141 1.15535 +5330 4 1.76535 25.1325 18.3092 -5.75322 -15.1157 -18.9078 +5331 6 53.2586 40.7003 24.294 -3.95682 23.2035 5.10337 +5332 4 53.3627 39.7881 24.0333 10.577 -13.1769 -1.30533 +5333 4 54.0929 41.151 24.0537 -8.8009 -7.19084 1.91562 +5334 6 47.531 32.0044 22.8424 -9.22212 4.73076 14.8806 +5335 4 47.3777 32.6735 23.5302 -5.63931 6.65432 -9.88941 +5336 4 48.2144 31.4763 23.2497 9.41484 -5.26157 -3.09765 +5337 6 24.6289 26.1478 33.0175 -22.0968 -9.02062 -12.6011 +5338 4 24.4656 25.5474 33.7557 -1.10221 8.12594 5.97613 +5339 4 25.4283 26.6445 33.1202 14.9272 4.196 4.65224 +5340 6 21.3417 17.0876 39.4763 -6.70912 6.89414 0.748051 +5341 4 22.0272 16.5901 39.8927 14.9242 -9.38388 2.18929 +5342 4 20.9728 17.5957 40.2063 -4.43123 6.71259 -1.60026 +5343 6 11.0417 40.4515 17.0271 -4.84825 -47.9733 -31.3307 +5344 4 11.617 41.1325 17.3235 21.4854 16.9952 0.793724 +5345 4 11.529 39.8797 16.3454 -22.439 27.66 32.3414 +5346 6 20.3522 21.2696 39.8718 -25.2322 13.8952 23.2629 +5347 4 20.7065 20.9823 39.0558 13.3567 -12.8249 -34.1322 +5348 4 21.0787 21.2544 40.4999 1.2931 1.07094 1.93889 +5349 6 2.11891 29.6947 22.5962 -10.9271 -4.15175 -1.48688 +5350 4 1.41229 29.0196 22.6861 11.0269 1.69063 -12.8134 +5351 4 2.97173 29.2673 22.4434 -6.16143 -1.40449 -3.11444 +5352 6 36.756 30.301 35.4561 22.3149 -30.6991 6.56967 +5353 4 36.1659 29.9908 36.1617 3.98829 10.9575 -2.82389 +5354 4 37.5905 29.761 35.5884 -25.1141 24.4323 0.251817 +5355 6 12.9563 4.31922 37.9158 -41.9162 -7.49401 17.923 +5356 4 12.213 3.67486 38.0016 27.2031 5.98064 4.05536 +5357 4 12.5797 5.11915 38.3509 20.8388 -3.72048 -10.4757 +5358 6 38.3368 5.25882 18.4553 -27.9454 13.7946 -11.1943 +5359 4 37.494 5.12162 18.8921 -4.17763 4.09508 -3.9191 +5360 4 38.9486 5.03087 19.1262 32.9808 -9.34357 19.7422 +5361 6 10.4991 9.23341 21.7308 -20.3579 1.12747 21.1104 +5362 4 10.1476 9.35811 22.629 -2.53412 -6.58654 -7.03761 +5363 4 11.4429 9.27697 21.8681 13.0367 -0.194449 -11.5952 +5364 6 0.510441 41.039 17.3204 -22.411 45.8537 -1.19125 +5365 4 1.10275 40.3438 17.515 21.9532 -27.5034 12.6219 +5366 4 0.955429 41.8901 17.5577 -0.403404 -22.4144 -8.21181 +5367 6 4.11028 5.06714 6.43108 -32.0559 -10.673 -25.0156 +5368 4 4.76196 4.43778 6.68194 21.2279 -22.0503 -6.17775 +5369 4 4.3376 5.79555 6.94869 8.69612 42.0455 26.6358 +5370 6 11.4527 25.4042 0.173069 -8.87291 20.1751 -4.43043 +5371 4 11.3037 26.302 0.51034 -2.48968 -2.12098 1.34892 +5372 4 12.3912 25.256 0.330533 -7.09022 -12.0676 2.67745 +5373 6 7.43008 21.5598 8.10589 6.84767 -16.7382 -30.018 +5374 4 7.67559 21.2373 7.18738 -12.1375 12.6211 33.8068 +5375 4 8.24892 21.8626 8.52003 -6.07298 -1.72571 -6.46698 +5376 6 47.5896 16.3642 25.2431 -28.5582 13.6976 -25.6498 +5377 4 46.6075 16.1608 25.1822 37.2389 5.55574 -4.66364 +5378 4 47.8562 16.8152 24.3682 -3.16196 -14.4146 40.515 +5379 6 30.9292 19.5125 39.8483 -41.4217 8.94898 -20.4144 +5380 4 31.859 19.4188 40.0164 22.9308 8.40553 1.58818 +5381 4 30.7224 20.3633 39.3589 16.5857 -27.3682 15.8932 +5382 6 20.3871 24.0387 39.4036 8.00795 23.2793 -8.75093 +5383 4 19.459 24.1701 39.2693 -20.2994 13.2523 2.58474 +5384 4 20.4244 23.1071 39.4874 5.50164 -36.2952 5.14995 +5385 6 45.8871 21.2471 41.1655 20.5283 25.7578 0.477301 +5386 4 46.6385 21.2626 41.7552 1.12624 -15.6366 20.1575 +5387 4 46.1812 21.9667 40.5962 -14.858 0.0662744 -14.6758 +5388 6 32.5732 28.1983 30.4559 17.8923 -19.7368 14.2663 +5389 4 32.9661 27.3096 30.6426 -14.7491 22.8943 -8.37245 +5390 4 33.2232 28.8091 30.8453 -8.57676 -1.81844 -4.53088 +5391 6 18.0207 1.32021 27.0363 -34.7874 1.53884 20.0911 +5392 4 17.0721 1.60205 27.1202 27.3864 -5.2263 -11.315 +5393 4 18.3294 1.50373 27.9381 11.4124 1.84961 -11.8648 +5394 6 39.378 24.9761 21.8758 -21.83 -3.15726 3.51608 +5395 4 39.2925 25.9351 21.9975 13.0773 -1.30024 -1.60914 +5396 4 38.5262 24.6687 22.2439 10.6836 3.42961 -4.87158 +5397 6 33.5904 21.3057 22.0908 0.876878 23.3779 1.34154 +5398 4 32.7037 21.4589 21.7601 -6.64994 -10.6299 -4.35651 +5399 4 34.0298 22.1428 21.8479 4.87062 -13.8873 3.79153 +5400 6 40.1162 15.0006 15.7553 -16.7667 -72.1851 -56.1125 +5401 4 39.3246 14.5665 15.2764 38.6699 22.9899 20.5541 +5402 4 39.7685 15.7046 16.224 -23.0828 51.553 35.6364 +5403 6 32.7063 17.9241 6.36312 -6.65812 28.0098 -27.693 +5404 4 32.6631 17.3286 7.08836 -4.96405 -26.2659 23.6138 +5405 4 32.2202 17.5402 5.61621 0.349997 -9.22032 2.43078 +5406 6 50.4717 15.9308 31.1336 -57.0185 -34.1342 43.3708 +5407 4 51.2677 16.1483 30.7347 55.5832 16.4654 -29.6643 +5408 4 50.5499 15.0059 31.4683 -2.42192 20.1529 -11.8828 +5409 6 23.8292 29.3322 31.6407 10.3974 -8.56959 5.42825 +5410 4 23.7096 29.6981 30.7618 4.3803 -0.813234 -2.10966 +5411 4 24.6813 28.8378 31.6594 -15.3785 13.3689 -4.34977 +5412 6 25.0524 41.6477 38.2806 4.00174 7.46449 -31.3583 +5413 4 25.6511 41.367 37.5454 -10.3054 -0.491554 23.0497 +5414 4 24.5276 0.474703 37.8884 8.98972 -6.87862 14.9811 +5415 6 14.3299 25.4693 7.99598 -51.8246 -23.5651 26.6357 +5416 4 15.0301 25.7523 7.4663 39.147 18.3395 -31.3738 +5417 4 13.6749 25.0466 7.38907 19.2382 9.49844 7.52052 +5418 6 17.2117 20.7467 5.34291 -12.6959 30.9635 29.5807 +5419 4 17.5658 20.2645 4.6512 13.3362 -42.6322 -45.6451 +5420 4 17.6752 21.5763 5.21476 -4.76461 12.1014 12.8322 +5421 6 18.8578 10.961 23.7113 11.9098 -52.6755 14.4862 +5422 4 18.5821 10.3312 23.0139 -2.7304 18.9854 0.947207 +5423 4 18.7069 11.8432 23.4586 -8.32501 34.3086 -18.4054 +5424 6 7.80658 41.3805 11.0401 -9.04392 11.0606 6.15122 +5425 4 8.00429 40.5098 11.4059 2.67644 4.01258 -4.23655 +5426 4 8.51691 0.066 11.3394 -1.81513 -7.16892 -1.05394 +5427 6 48.6966 23.1832 34.0648 -27.3561 -6.76338 -18.0805 +5428 4 48.0792 22.9132 33.32 19.6766 11.2437 24.8207 +5429 4 49.5669 23.23 33.6693 11.2336 0.854645 -6.12438 +5430 6 53.7246 23.5588 15.3422 -2.2993 4.88061 -38.5045 +5431 4 54.0115 23.9686 14.4981 1.04624 9.96871 20.6807 +5432 4 53.2132 22.8493 14.9574 -7.54922 -9.79714 16.7607 +5433 6 22.2409 5.63035 9.83732 -4.74687 0.990813 -28.4051 +5434 4 21.8007 4.9012 9.36518 5.41421 2.33681 17.3637 +5435 4 22.5704 6.16354 9.07597 -3.08255 -9.23766 25.1176 +5436 6 33.6677 8.38805 9.07277 4.65141 2.45263 2.68713 +5437 4 32.9476 8.96499 9.32099 -11.143 10.7473 10.4723 +5438 4 33.4213 8.08448 8.2012 2.38155 -0.0587928 -10.5973 +5439 6 47.3188 37.7205 20.3441 15.215 11.7573 -25.0114 +5440 4 47.5704 37.5879 19.4187 8.2864 3.06637 8.88956 +5441 4 46.6261 37.0853 20.3703 -21.7602 -22.9037 19.9419 +5442 6 30.8605 16.7391 10.6102 -28.0995 -48.2853 23.2284 +5443 4 30.4428 17.1675 11.4048 8.00556 -5.70758 -17.8294 +5444 4 30.5213 15.7576 10.5828 6.17084 54.1408 -3.58748 +5445 6 48.1227 27.723 10.1192 -17.271 38.6552 19.8549 +5446 4 48.941 27.5885 10.6019 15.4404 -6.10886 -7.64033 +5447 4 47.9667 27.1056 9.42146 1.69339 -23.2576 -13.9441 +5448 6 27.3465 38.6397 25.5972 -19.3603 -43.7567 25.3821 +5449 4 28.2552 38.3171 25.6348 3.73027 6.4174 -6.06634 +5450 4 27.3175 39.4354 25.1025 9.7616 28.5552 -11.1584 +5451 6 33.3485 5.72785 21.4502 -30.5322 15.1217 -10.2054 +5452 4 32.7106 6.21453 20.8566 24.3968 -18.0484 15.2917 +5453 4 34.2142 6.02589 21.2258 21.3261 10.3595 -12.9949 +5454 6 25.3097 5.14436 4.52462 -12.6707 -6.42781 10.7366 +5455 4 25.8166 5.03621 5.34324 9.24373 -0.000563512 -7.52253 +5456 4 24.4109 4.89546 4.80865 9.45245 1.955 -8.20101 +5457 6 40.4804 35.6472 19.1595 -4.18239 -17.2552 -25.1441 +5458 4 40.6473 35.1871 19.989 -0.677015 6.66802 10.9293 +5459 4 40.3876 36.5867 19.2889 2.08163 9.85771 9.62751 +5460 6 49.6466 30.6357 19.0258 14.8172 21.4531 -43.5404 +5461 4 50.0494 29.991 18.4245 -6.82309 -11.6442 2.45506 +5462 4 49.4912 30.1943 19.8303 -8.11919 -24.8089 39.0949 +5463 6 42.1414 28.3198 17.0336 30.9261 -8.96587 16.5499 +5464 4 41.9014 28.1134 16.1233 0.612516 -1.09878 -6.61247 +5465 4 42.9986 27.8356 17.2327 -32.0588 11.6021 -17.9905 +5466 6 47.7009 24.529 36.3602 12.6164 -10.6945 -29.4467 +5467 4 46.9511 23.9476 36.4057 -12.614 -6.01445 14.1932 +5468 4 48.02 24.3175 35.4647 6.89481 1.31964 6.68358 +5469 6 19.3487 26.9773 19.8132 -7.91098 29.1703 -3.69101 +5470 4 19.5772 26.0513 19.7652 -2.42994 -17.6971 2.90599 +5471 4 18.7132 27.1892 20.5145 5.94626 -13.5516 -3.80193 +5472 6 47.0594 26.8038 37.5124 29.171 -27.35 55.5912 +5473 4 46.5442 27.3901 37.0243 -28.7601 35.2651 -40.4696 +5474 4 47.4575 26.1126 36.9775 -8.83233 1.8809 -11.4479 +5475 6 9.306 24.6801 40.2841 31.4937 0.109789 0.329283 +5476 4 9.78189 23.9102 39.8717 -14.0424 16.7407 17.3327 +5477 4 10.0272 25.2082 40.7306 -19.6308 -16.1327 -14.1874 +5478 6 14.4855 17.9139 14.2735 23.8217 -2.3356 -5.96097 +5479 4 13.7756 18.1909 13.6871 -0.445295 3.10639 3.20472 +5480 4 15.2926 17.8532 13.6969 -24.9099 1.36359 15.4275 +5481 6 37.1333 38.6708 18.7289 9.24178 15.507 -32.6939 +5482 4 36.7257 39.5382 18.5851 -4.02817 -0.227247 6.07181 +5483 4 37.6697 38.5833 17.9067 -2.91955 -11.3843 16.172 +5484 6 11.4153 5.92336 21.4477 15.4675 -15.5323 24.3843 +5485 4 12.0347 5.46444 22.0611 -14.8481 11.1792 -11.8992 +5486 4 10.9828 5.22117 20.955 -5.02219 -4.37746 -7.57367 +5487 6 4.24672 30.7112 16.2271 25.0754 -37.7862 10.5022 +5488 4 4.05441 31.4608 15.7204 -4.71706 34.9582 -31.1175 +5489 4 3.72964 30.8334 16.9988 -11.892 -2.06994 24.4228 +5490 6 17.6689 16.0105 27.0706 -11.532 -19.4613 -16.5334 +5491 4 17.475 15.0322 27.0999 0.550485 29.0366 -12.0979 +5492 4 17.2014 16.3875 26.2691 10.8221 -16.0252 20.0561 +5493 6 36.4979 8.6445 40.4253 22.1182 5.90925 -1.87084 +5494 4 36.6649 9.56092 40.6574 -3.64727 2.10984 0.486612 +5495 4 35.6642 8.36755 40.7885 -12.5441 -1.64485 2.44437 +5496 6 13.6104 12.9476 3.01337 -0.796658 -1.76047 52.4558 +5497 4 13.281 12.534 3.85665 2.0295 3.09436 -35.1239 +5498 4 14.3672 13.4568 3.35498 1.79634 -1.71495 -16.7359 +5499 6 38.5663 20.1511 21.6276 16.2684 -2.59448 10.3838 +5500 4 39.225 20.3435 20.957 3.66548 0.723189 -1.42015 +5501 4 37.7399 20.1987 21.178 -26.4348 -4.9091 -11.1397 +5502 6 51.0002 10.2707 30.836 -20.0759 -41.5967 21.7358 +5503 4 51.4945 11.0341 30.626 15.2265 30.1997 -10.6067 +5504 4 50.365 10.1656 30.1217 2.42758 1.75416 -9.76943 +5505 6 16.2768 2.44039 41.3342 24.5898 23.894 -47.9169 +5506 4 15.7659 1.68969 41.4668 -26.4768 -52.1654 31.458 +5507 4 16.2309 2.46185 40.3616 9.12406 8.41144 7.6857 +5508 6 16.5823 4.96192 41.8916 -4.82165 52.2801 -70.6027 +5509 4 16.7504 4.9538 0.881833 10.2709 -3.72182 62.3109 +5510 4 16.3825 4.09214 41.6138 -6.48385 -26.7637 5.90228 +5511 6 38.2132 37.6512 20.9834 35.6931 -0.0015793 9.16781 +5512 4 38.1132 38.2158 20.1985 1.71026 -5.63736 5.42755 +5513 4 39.175 37.679 21.2752 -35.8773 5.52261 -11.9395 +5514 6 27.3063 1.90932 15.7743 -36.1781 7.04456 22.02 +5515 4 27.5288 1.21363 15.1745 3.62804 -9.29946 -19.0329 +5516 4 26.3092 1.89423 15.8276 27.8398 0.929522 -3.41863 +5517 6 29.0129 12.4346 37.8081 29.6396 -2.3639 23.3235 +5518 4 29.5703 13.228 37.8521 -9.25731 3.38449 -11.2245 +5519 4 29.432 11.8866 38.5178 -20.735 6.92768 -10.3763 +5520 6 46.0725 20.1624 18.9069 6.39102 14.9163 -14.6323 +5521 4 45.1723 20.516 18.8892 1.91785 -0.379773 0.405435 +5522 4 46.587 20.7656 18.3221 -3.54001 -13.7442 9.74416 +5523 6 2.03634 38.6845 18.4933 3.82981 -3.85695 21.6638 +5524 4 2.81563 38.6864 19.0472 23.4807 10.2435 -12.678 +5525 4 1.45125 38.3557 19.1766 -27.1945 -1.99387 -8.3623 +5526 6 44.0469 24.9707 25.966 7.80173 10.6441 20.9452 +5527 4 44.2747 24.0363 26.0952 1.37736 2.33249 -4.33209 +5528 4 43.5784 25.0701 25.1359 -3.49858 -7.6437 -6.59112 +5529 6 5.98346 26.6137 4.53144 23.0758 4.04073 24.4329 +5530 4 6.55391 27.1627 5.13089 -15.1794 -12.3526 -15.6845 +5531 4 6.29729 25.6938 4.67268 -13.7287 18.2257 -9.78447 +5532 6 0.087877 23.2081 10.934 24.9145 3.46447 1.10559 +5533 4 0.685292 23.7315 10.3726 -8.08066 -2.01306 3.92681 +5534 4 0.721975 22.7627 11.5282 -19.4067 -0.934622 -1.78644 +5535 6 39.1228 20.6282 12.8796 23.5823 -4.01912 3.74068 +5536 4 40.0483 20.9095 13.1274 -25.2182 -11.8294 -4.75086 +5537 4 38.9288 21.0058 12.0111 3.51405 8.21934 1.48951 +5538 6 39.9585 39.9542 18.8548 8.25477 7.63818 -34.14 +5539 4 39.6086 40.5348 18.1328 12.8912 -23.3113 16.3656 +5540 4 39.4227 40.1355 19.596 -22.4924 5.25798 25.9214 +5541 6 49.2764 23.011 30.5163 -3.77364 -44.6036 15.8547 +5542 4 49.4289 23.7872 30.0082 18.6126 30.182 -14.9565 +5543 4 49.9621 22.8706 31.1946 3.66181 18.5012 -4.70792 +5544 6 10.3518 2.34263 9.13761 -0.60969 70.0656 33.4022 +5545 4 10.2194 1.51752 8.76453 -19.3013 -48.5596 -30.1763 +5546 4 9.57958 2.95755 9.02478 16.8019 -18.7251 -1.57756 +5547 6 9.61453 40.9339 19.7468 19.8516 -54.9951 -16.0575 +5548 4 9.63195 40.6865 18.7859 0.317082 16.3896 20.6195 +5549 4 10.0376 40.0904 20.1458 -24.9194 43.0231 -10.2629 +5550 6 29.2525 5.10109 17.4961 7.67774 22.6856 2.90325 +5551 4 29.0408 4.77134 16.6193 -6.82779 -3.03985 -6.7526 +5552 4 29.5295 6.02934 17.3335 -2.58265 -16.5067 4.76001 +5553 6 27.0985 15.4102 3.23556 -13.4453 -81.1273 -7.3603 +5554 4 27.3652 16.2806 3.27349 18.8182 67.1491 11.283 +5555 4 27.7776 14.8512 3.68225 -14.3437 21.6428 -0.863725 +5556 6 32.8444 39.3852 25.121 -7.01244 -52.8845 44.4676 +5557 4 32.5131 40.2222 24.9368 -10.8075 51.8916 -16.2411 +5558 4 32.4445 39.2315 26.0289 16.1191 -0.874654 -30.671 +5559 6 34.9513 7.88207 31.2328 20.4504 58.5219 2.42802 +5560 4 34.2036 8.45679 31.498 3.65199 -12.2289 -1.35309 +5561 4 34.6861 6.99719 31.2488 -20.0023 -44.0519 1.25651 +5562 6 6.12467 36.7605 26.1486 23.5936 30.152 20.8626 +5563 4 6.61267 37.4751 26.6609 -18.7565 -29.2185 -15.3031 +5564 4 6.64666 36.6639 25.3566 0.873799 -8.15108 -9.63468 +5565 6 6.01736 25.8242 24.1032 -23.71 11.4997 43.6127 +5566 4 6.27054 25.4519 24.9889 5.69321 0.899098 -34.3464 +5567 4 5.25039 26.3671 24.4036 11.002 -12.3451 -22.9516 +5568 6 45.616 24.3868 2.54557 6.93899 11.9467 -1.18645 +5569 4 46.5025 24.2318 2.18535 0.269069 -11.0786 2.08994 +5570 4 45.6283 24.2142 3.48441 5.93067 -6.10702 12.3332 +5571 6 15.5106 11.7053 32.6869 22.7313 15.5035 25.4621 +5572 4 15.7644 12.551 33.1413 -9.31293 -24.2108 -12.4541 +5573 4 14.956 11.9719 31.9681 -12.2379 8.7831 -14.7046 +5574 6 46.4141 17.7037 37.4783 -24.8433 -42.9552 -46.1347 +5575 4 46.5841 17.8832 38.3706 6.4658 9.03355 44.3658 +5576 4 46.0203 16.778 37.4148 6.08678 36.5836 2.96135 +5577 6 39.713 20.917 18.528 13.2313 30.5311 40.8197 +5578 4 40.433 20.5782 18.0298 13.2747 -18.0123 -24.5712 +5579 4 40.2054 21.5165 19.1543 -30.2447 -12.7963 -15.6911 +5580 6 23.8051 28.0334 36.6648 -18.7533 17.1228 48.8478 +5581 4 23.301 27.37 37.1661 8.15196 -5.41595 -20.5023 +5582 4 23.699 28.7533 37.3439 14.557 -4.10395 -29.4534 +5583 6 23.235 0.659798 30.8906 16.7198 -34.3804 0.301059 +5584 4 23.3562 41.8891 31.5781 -2.93034 5.1259 -1.85649 +5585 4 23.9222 0.433479 30.2226 -16.4688 10.6885 3.12481 +5586 6 37.1438 6.89027 28.2945 -2.75708 2.50278 32.0481 +5587 4 36.7625 6.23385 28.9496 14.7229 22.3106 -21.8828 +5588 4 37.4874 7.65333 28.8474 -13.0775 -21.14 -18.6628 +5589 6 3.23769 6.61111 12.3846 0.723209 -17.9385 -9.61551 +5590 4 2.93962 6.7917 11.4726 6.04883 11.0603 10.3219 +5591 4 3.59705 5.70622 12.3141 -7.8292 10.6871 9.81534 +5592 6 12.6213 19.1513 31.1215 -11.7593 -39.2703 -9.13055 +5593 4 12.5689 18.1911 31.4279 4.41954 36.1073 -0.401864 +5594 4 12.3049 19.0952 30.1995 4.23471 8.33584 13.9505 +5595 6 15.1895 38.3194 41.5508 -8.26313 0.106571 5.96729 +5596 4 15.4027 38.685 40.6867 1.58925 3.7734 1.08261 +5597 4 15.977 37.8419 41.8199 8.82113 -1.67422 -0.112624 +5598 6 49.6344 33.3417 19.6414 -43.1776 -42.2962 -0.847743 +5599 4 48.6794 33.3996 19.9697 35.2792 3.84356 -17.7841 +5600 4 49.66 32.3974 19.2778 11.8172 40.1309 17.1575 +5601 6 6.36572 2.78375 29.9004 1.05055 15.8156 -22.8281 +5602 4 6.36575 3.75042 29.7262 1.90425 -15.9719 7.25575 +5603 4 5.96593 2.68858 30.7619 0.24665 -4.47807 16.8647 +5604 6 13.1696 31.768 30.2754 -6.44409 10.1839 -14.6274 +5605 4 12.7931 32.0108 29.386 8.00869 -8.49993 19.6421 +5606 4 12.9985 30.8211 30.4317 -1.17466 7.15103 -3.10169 +5607 6 32.315 32.2433 24.9103 28.3535 -13.0924 -48.465 +5608 4 32.6582 31.5201 24.3183 -18.8106 4.4732 28.5514 +5609 4 32.6906 33.004 24.4312 -3.21058 9.63112 20.1287 +5610 6 42.0003 14.5628 37.421 -39.889 12.6212 -8.37855 +5611 4 41.095 14.1415 37.3281 37.9102 -1.96214 -0.320241 +5612 4 42.7025 13.9066 37.3517 -4.02931 -15.6388 2.60245 +5613 6 11.8892 7.23447 27.6701 3.45884 -4.12236 4.5236 +5614 4 11.8415 6.40302 28.2109 -4.80024 17.2153 -14.4092 +5615 4 11.297 7.16355 26.8983 -0.411327 -9.99206 8.34553 +5616 6 14.2054 37.5349 6.88535 -5.50304 -50.1586 -23.8091 +5617 4 14.4448 38.4425 6.82842 11.1201 34.2121 -5.16838 +5618 4 14.5404 37.0855 6.04727 -8.45912 19.5264 31.302 +5619 6 14.2389 30.7101 36.0658 7.9951 22.3707 -6.00421 +5620 4 14.3369 30.7582 35.119 5.20948 5.89711 -15.5268 +5621 4 14.162 29.7856 36.1796 -2.50712 -40.828 17.27 +5622 6 16.4199 33.6465 5.49971 39.8982 -12.4718 -37.0106 +5623 4 16.8881 34.472 5.38053 -10.1033 13.7438 12.8324 +5624 4 16.9383 33.116 4.82328 -31.4907 -2.1142 22.2677 +5625 6 23.0347 17.1509 7.84843 -2.98061 53.305 10.417 +5626 4 22.2528 17.4913 7.37616 0.35347 -20.1342 1.7373 +5627 4 23.3535 18.0122 8.2624 2.91922 -40.8936 -9.01863 +5628 6 51.739 20.8998 27.7117 45.1346 -9.91933 19.8422 +5629 4 51.4539 20.5938 28.5983 0.576611 5.87017 -14.8878 +5630 4 52.7517 20.9693 27.7878 -43.3794 -0.870523 -11.1135 +5631 6 2.19386 27.6013 28.8077 21.9852 1.77593 -20.6905 +5632 4 2.90112 28.2633 28.7865 -8.94698 7.25322 21.5481 +5633 4 2.57794 26.9939 28.1568 -21.2327 -10.3447 8.82052 +5634 6 17.2209 14.3445 7.70498 -9.6153 -40.0176 25.3709 +5635 4 16.7414 14.2178 8.5755 19.2823 5.01031 -25.0594 +5636 4 17.7242 13.4894 7.54274 -12.7499 32.9606 1.11211 +5637 6 12.4553 8.94194 14.7093 23.4905 -30.5738 22.1451 +5638 4 12.3295 7.96561 14.6517 -10.6336 18.1935 -14.5798 +5639 4 13.0902 8.95069 15.466 -13.8235 22.031 -14.7981 +5640 6 42.4163 38.0607 9.75492 -41.3892 12.3524 0.930734 +5641 4 43.2155 37.8504 10.1985 23.5031 -2.65638 19.8551 +5642 4 41.8128 38.5249 10.3845 19.1619 -5.0707 -9.72644 +5643 6 51.8291 30.3524 28.2725 -23.4976 -15.3182 24.0858 +5644 4 51.4769 31.1806 28.0071 -16.9091 20.9854 -6.54852 +5645 4 52.5669 30.2698 27.7075 37.0459 -10.0857 -13.876 +5646 6 0.173291 18.5306 4.58887 -6.78508 26.3933 6.63194 +5647 4 0.366643 18.0957 3.77581 2.61413 -8.62723 -27.1515 +5648 4 0.528197 17.9664 5.25604 0.668563 -20.2899 17.5992 +5649 6 34.1542 0.618182 3.01035 -64.6642 7.59467 -29.5426 +5650 4 33.2756 0.91071 2.55681 38.9521 -14.8268 28.0312 +5651 4 34.8139 1.0189 2.46529 20.392 14.9436 -5.19898 +5652 6 49.1703 17.2445 23.163 11.3421 -28.7232 -23.3687 +5653 4 50.0948 17.5226 22.997 -11.4987 -1.8789 7.34388 +5654 4 49.1149 16.3391 22.7575 3.35316 27.0342 8.27414 +5655 6 23.1508 6.50484 23.6205 15.3745 23.1125 -33.0506 +5656 4 23.1854 7.14565 22.8174 -14.1016 -25.0292 28.8988 +5657 4 22.2566 6.27815 23.8868 -11.3625 11.3028 -1.57795 +5658 6 11.0777 24.0866 29.2726 3.42799 -14.5151 -26.2344 +5659 4 11.3051 23.4915 28.5104 -10.7193 12.1306 15.2701 +5660 4 11.7189 23.8646 29.9475 6.00027 1.59973 10.1126 +5661 6 36.5499 4.08922 21.6769 -9.80126 5.87302 -21.3361 +5662 4 36.3976 4.50823 22.521 3.21878 -0.144303 13.033 +5663 4 36.3054 4.80832 21.0596 6.63301 -13.9203 1.83546 +5664 6 31.3023 25.6432 24.5943 15.0376 6.85795 28.0728 +5665 4 31.291 26.2789 25.3519 -12.6017 -14.5788 -25.478 +5666 4 32.0941 25.1064 24.7955 -9.59576 -0.449362 -7.93794 +5667 6 42.6065 23.029 14.7662 -46.2562 -12.0705 -53.1337 +5668 4 42.8654 23.3474 13.8766 8.33796 6.77145 13.2285 +5669 4 43.1929 23.285 15.4255 44.8404 21.8098 38.991 +5670 6 14.3111 11.6689 8.88632 -19.0153 -23.9468 -21.906 +5671 4 13.3495 11.3817 8.87766 31.9146 14.5471 0.24728 +5672 4 14.742 11.0378 8.25313 -7.14597 12.5116 20.7778 +5673 6 21.4992 2.13393 3.40246 8.36864 -2.88126 -9.61958 +5674 4 22.4231 2.22963 3.69686 -12.58 -3.45743 -2.69439 +5675 4 21.4721 1.34946 2.81138 2.62282 6.56171 18.4043 +5676 6 22.4667 27.6841 39.0793 -16.1771 -11.2193 -33.3168 +5677 4 22.9487 28.2311 39.6723 13.8114 13.1168 21.0188 +5678 4 22.2331 26.8853 39.529 -0.753476 -8.75647 11.2468 +5679 6 37.2752 33.5075 30.0534 -5.09816 -29.8969 21.2662 +5680 4 36.5321 32.9121 30.2938 11.1992 13.6878 -5.37502 +5681 4 38.0391 33.1092 30.5204 -9.59535 7.6329 -11.7718 +5682 6 41.8356 20.8755 40.0084 -30.1785 -26.2846 -15.3963 +5683 4 40.891 20.6843 40.2338 21.7839 7.55089 -6.55796 +5684 4 42.213 21.2736 40.7728 12.4306 8.07023 23.0746 +5685 6 10.0585 31.1051 22.2503 24.8691 -18.1602 32.094 +5686 4 10.0242 30.9652 23.2199 -0.323131 -4.21186 -18.2592 +5687 4 9.26251 31.5457 22.0526 -32.5358 14.9165 -12.561 +5688 6 24.2061 35.3797 6.65176 29.8647 -7.74501 -52.0461 +5689 4 23.2981 35.13 6.46942 -12.5131 3.59528 11.7489 +5690 4 24.436 35.6291 7.5325 -13.5066 3.92126 26.0938 +5691 6 54.2205 13.3707 18.7548 -14.8606 0.23157 2.49876 +5692 4 53.5905 13.2954 18.0026 12.0308 5.79113 16.3195 +5693 4 53.7072 13.5032 19.578 4.97112 -2.65932 -16.1217 +5694 6 12.4895 25.0856 17.4479 -5.54126 21.12 19.6166 +5695 4 12.0527 25.8035 17.9613 1.96295 -15.4272 -10.9144 +5696 4 12.9797 24.5872 18.1192 -7.22993 -2.38631 -13.5888 +5697 6 22.3914 33.9622 18.8899 -17.7941 -3.8788 -25.186 +5698 4 22.7777 34.3519 18.0802 1.20341 3.55679 12.7761 +5699 4 21.5828 33.5138 18.532 26.0363 5.82114 13.25 +5700 6 24.4442 12.917 5.83205 -1.35281 -9.13891 6.68087 +5701 4 24.5112 13.8355 6.04562 11.139 23.8521 5.95609 +5702 4 23.7978 12.9208 5.12829 -4.38592 -8.75699 -5.70796 +5703 6 13.4045 11.2384 28.602 -9.94106 -32.5269 -0.345522 +5704 4 13.7125 10.4202 28.1467 1.06973 22.7078 1.68844 +5705 4 12.6883 10.856 29.1417 2.50959 12.0169 -5.49025 +5706 6 20.9681 34.6931 21.1354 15.1203 14.42 -6.16036 +5707 4 21.5009 35.1121 21.8248 -8.94458 -7.77672 4.1779 +5708 4 21.5063 34.8208 20.3262 -11.2236 -10.4562 8.09593 +5709 6 37.1336 34.5207 26.1541 -9.5297 -36.7224 -3.07541 +5710 4 37.2109 34.2142 25.2288 3.21082 15.1766 11.7274 +5711 4 37.5352 35.3664 26.2639 8.9577 18.3348 -6.65469 +5712 6 49.3622 27.1182 23.4746 39.7066 -11.0301 13.9767 +5713 4 48.4746 27.3502 23.3119 -43.65 9.96054 -8.06751 +5714 4 49.6716 26.7458 22.6451 -3.30563 -9.15784 -7.68388 +5715 6 2.6564 41.733 27.6477 -1.65257 -10.3676 0.180548 +5716 4 2.5349 41.5868 26.6785 2.71482 14.5166 10.808 +5717 4 3.44733 0.360291 27.8573 -13.8821 -2.9337 -13.5775 +5718 6 28.2538 5.65865 0.855763 -50.2522 -11.1502 7.99105 +5719 4 29.1126 5.92525 0.635025 43.8938 8.11388 -11.2713 +5720 4 28.2366 4.68907 0.832778 5.05155 4.08711 2.73992 +5721 6 46.3376 19.9476 30.6448 -5.32264 7.02196 22.3264 +5722 4 46.9473 19.8004 29.9179 3.84913 9.17517 -5.42643 +5723 4 46.6125 20.7672 31.1318 -5.12963 -19.3092 -16.4827 +5724 6 3.64577 25.7701 21.5553 -12.766 27.4814 -12.397 +5725 4 3.72382 24.8593 21.8343 3.84868 -9.88757 -5.52558 +5726 4 3.13913 25.8588 20.7173 13.2009 -15.3518 9.10855 +5727 6 2.75122 19.0968 29.6319 -2.61118 -0.882922 8.96218 +5728 4 3.5891 18.6871 29.8565 3.14038 -9.81989 10.1431 +5729 4 2.90737 19.4327 28.7602 3.1882 14.1904 -12.7773 +5730 6 11.8953 35.7778 24.2646 -23.8517 23.4638 0.926703 +5731 4 12.2722 34.9198 24.2954 23.5909 -23.1933 0.784725 +5732 4 12.5229 36.3761 23.8548 12.2449 3.68762 -3.83655 +5733 6 52.3409 30.3775 14.3038 25.9342 24.3497 3.27132 +5734 4 52.8186 31.1218 14.7277 1.28259 -10.3571 -1.87569 +5735 4 51.5459 30.7912 14.0165 -25.7225 7.74731 -5.34623 +5736 6 0.083662 24.3704 32.1159 7.87696 -1.86575 0.949534 +5737 4 0.925887 24.7254 31.8116 -7.58302 1.2158 -10.0766 +5738 4 0.064605 24.6797 33.0182 -11.6947 5.89195 12.8097 +5739 6 31.4941 23.7355 38.8139 13.6067 4.55671 22.3988 +5740 4 31.5922 23.3599 39.6955 6.6148 17.5079 8.63317 +5741 4 30.9989 23.0266 38.4646 -21.4094 -18.5611 -29.2329 +5742 6 52.1193 21.6104 3.49599 14.6151 -31.0847 -13.388 +5743 4 52.9641 21.5934 2.99085 -20.8635 4.42776 5.19501 +5744 4 52.1025 22.4297 3.95509 1.85636 27.8943 8.87727 +5745 6 31.7523 33.9412 11.6017 9.59211 -24.6365 -8.99112 +5746 4 31.343 34.2459 12.4067 -7.95657 10.1636 10.9534 +5747 4 32.0734 33.0348 11.7994 -4.73133 20.193 -2.42319 +5748 6 7.03486 17.6719 16.6685 29.0057 -41.5114 -49.367 +5749 4 6.91092 17.0215 17.3537 -7.78637 4.64801 28.8113 +5750 4 7.29826 17.0034 15.9319 -18.9591 50.1453 28.7374 +5751 6 51.8542 41.8728 22.1898 10.246 17.2442 -13.5357 +5752 4 52.3028 41.4443 22.9054 19.3182 -6.61148 18.5368 +5753 4 51.1068 41.3135 22.0792 -27.0964 -11.4612 -2.03348 +5754 6 50.8737 9.93347 25.9376 -32.929 -21.31 0.307119 +5755 4 50.6075 10.0984 25.0351 -2.54905 2.45869 -5.94774 +5756 4 51.7134 10.3221 26.0527 29.2363 20.0336 5.9403 +5757 6 9.00178 39.8723 13.8451 -19.3622 -18.1235 -30.983 +5758 4 9.55792 39.3182 14.3856 9.60602 -5.37935 8.26515 +5759 4 8.70771 39.29 13.0873 14.4347 20.6992 23.854 +5760 6 40.6986 25.5526 0.136544 19.9096 -17.3535 33.0343 +5761 4 40.3666 25.3638 1.04053 0.834228 7.76146 -13.9079 +5762 4 41.6521 25.7245 0.296606 -16.7956 -8.725 -14.7957 +5763 6 46.6823 7.83196 22.8561 10.1499 25.8504 33.9562 +5764 4 46.2788 7.49308 23.6743 -2.78909 -8.0392 -13.1915 +5765 4 47.099 8.65892 23.1926 -4.50937 -8.82075 -14.1875 +5766 6 20.9875 12.9068 9.95805 -11.691 32.2034 24.7109 +5767 4 21.4351 12.3054 10.5167 21.854 -26.8991 22.1196 +5768 4 21.3309 12.7465 9.11062 12.4417 -9.66517 -44.3579 +5769 6 24.8453 0.514421 28.6038 13.082 22.7197 -2.81433 +5770 4 24.715 0.071792 27.7548 -6.16819 -1.63374 -2.91335 +5771 4 25.0442 1.45997 28.4028 -6.72102 -19.281 3.08734 +5772 6 9.94041 22.6855 8.28517 -18.2906 18.759 -35.6321 +5773 4 10.3442 21.9586 7.83344 17.071 -18.1108 1.7387 +5774 4 9.60436 23.1702 7.48056 7.13277 7.40532 33.7222 +5775 6 33.2759 9.25429 23.8257 8.37106 -55.2845 13.9355 +5776 4 33.3237 10.1123 23.4806 -1.26345 47.1757 -20.4798 +5777 4 34.1087 8.81977 23.5578 -8.47821 6.16632 5.2483 +5778 6 47.7984 20.3614 34.2959 -41.6158 20.0741 -32.6301 +5779 4 47.162 20.9095 33.7523 35.4977 -6.5354 18.8426 +5780 4 47.2264 19.5923 34.4121 13.8381 -6.37745 11.1074 +5781 6 7.49292 13.4971 41.09 9.79805 -11.8131 -23.6679 +5782 4 7.49901 13.1324 40.1715 -6.0705 12.8605 17.5951 +5783 4 8.32745 13.1637 41.4633 -5.36906 3.36653 2.36319 +5784 6 9.96112 23.6102 1.61114 1.89646 0.256416 -8.05524 +5785 4 10.3422 24.1467 0.893187 3.70522 0.0162214 12.766 +5786 4 9.63217 22.8308 1.16111 -2.5861 -8.4474 -3.4617 +5787 6 27.3279 14.1675 11.3384 -16.3978 3.93745 18.7515 +5788 4 27.0565 14.7974 10.6584 -0.154384 0.736593 1.51299 +5789 4 26.9739 14.5213 12.1957 15.9081 -3.44829 -24.7787 +5790 6 25.8416 31.7729 17.8867 -18.6075 -57.137 -13.4601 +5791 4 26.5498 31.1652 17.5816 -7.88637 19.42 8.67928 +5792 4 26.1364 32.6121 18.1157 31.0786 47.9057 11.8145 +5793 6 28.5054 34.3394 0.220618 54.67 33.5077 11.5224 +5794 4 29.0324 33.8757 0.885908 -4.94848 -3.20805 0.921423 +5795 4 27.711 33.8992 0.092994 -46.8158 -31.9819 -6.78258 +5796 6 39.4821 27.6754 22.7241 37.6977 26.8974 -34.7457 +5797 4 38.562 27.8477 22.7631 -35.1425 8.51836 6.28403 +5798 4 39.8483 28.4606 22.2037 -4.4779 -30.5719 17.4824 +5799 6 19.3989 35.5068 37.6449 44.7238 7.00696 26.241 +5800 4 18.7939 34.9286 37.217 -17.2642 -20.3375 -13.2178 +5801 4 20.0787 34.9056 38.0699 -27.4009 15.1777 -18.4057 +5802 6 40.2622 30.2205 10.7395 23.7464 -4.20556 -44.2191 +5803 4 39.872 30.2327 11.5724 -12.5687 -7.32393 56.9787 +5804 4 39.6265 30.6987 10.2193 -5.46151 14.1383 -16.826 +5805 6 44.8252 28.4803 36.0885 -55.5401 -40.4399 48.4955 +5806 4 44.0914 27.9458 36.6324 49.8455 26.3412 -39.6007 +5807 4 44.7386 29.3482 36.4954 11.2485 4.05282 -13.3799 +5808 6 17.9305 13.9374 34.278 5.37655 43.1893 -39.9004 +5809 4 17.3503 14.7126 34.0365 12.4853 -29.216 13.3111 +5810 4 17.5732 13.4499 34.9957 -23.6035 -11.4222 25.4792 +5811 6 22.772 11.7897 25.9182 -5.92321 66.9234 -24.4623 +5812 4 22.4079 10.9608 26.1065 -2.80798 -46.2844 14.8143 +5813 4 23.7282 11.8442 25.9391 13.2658 -20.917 3.34216 +5814 6 27.9678 31.9745 40.3581 9.67064 -3.036 11.5355 +5815 4 28.3415 32.7469 39.952 3.83939 12.9153 -6.44865 +5816 4 27.8423 31.3481 39.6454 -9.64166 -7.41544 0.62615 +5817 6 29.7189 5.14175 29.7003 46.1252 -36.6163 -19.9261 +5818 4 29.2969 5.47215 30.4671 -15.8461 16.6952 32.1509 +5819 4 30.5834 4.69597 30.0017 -39.473 23.5261 -13.8417 +5820 6 3.10812 21.482 2.76797 0.178067 -30.2305 -7.76436 +5821 4 2.88389 22.394 2.68207 -8.68283 21.8462 0.431797 +5822 4 2.52465 20.9987 2.15107 4.11904 7.00085 10.9335 +5823 6 13.6455 30.6616 39.7413 -31.0251 6.24286 -53.6991 +5824 4 14.4958 30.9276 39.9901 40.59 7.52955 18.7737 +5825 4 13.6028 30.9637 38.7781 -13.7388 -14.6365 40.9566 +5826 6 39.1879 23.0833 28.2631 23.8153 34.0131 -40.8644 +5827 4 39.3603 23.1915 27.276 -9.32936 -4.03115 31.7012 +5828 4 38.6771 22.3028 28.3825 -19.3689 -24.2853 3.44718 +5829 6 16.9942 23.7475 0.782551 23.2332 -11.0525 -6.02825 +5830 4 16.1835 23.4907 1.22514 -0.204047 -3.07314 3.44284 +5831 4 17.6924 23.1245 1.11262 -18.9135 18.2649 -2.71213 +5832 6 0.34625 33.6655 13.0265 -29.0282 32.855 38.2597 +5833 4 54.9333 33.1158 13.7076 7.16186 -20.0974 -8.4449 +5834 4 0.196186 34.5312 13.5136 21.864 -23.0202 -35.8666 +5835 6 49.1134 40.6592 16.9502 -22.6074 7.13526 -12.7963 +5836 4 49.0929 41.0585 16.0481 9.95068 -10.3513 11.1088 +5837 4 48.1763 40.6949 17.2078 7.5264 3.31219 -3.37923 +5838 6 52.1371 39.9932 15.179 23.5783 8.13152 6.60826 +5839 4 51.9212 40.0798 16.1068 2.92809 -1.65288 7.91558 +5840 4 51.3496 39.6649 14.7978 -27.1925 -6.99882 -20.2103 +5841 6 29.0492 37.0934 37.8397 27.862 0.580994 -15.5106 +5842 4 29.7824 36.6456 38.29 -13.83 -0.942856 -3.03347 +5843 4 28.3401 37.1923 38.4583 -14.8343 8.34268 17.6028 +5844 6 4.87483 1.47389 27.5722 8.99005 1.78018 0.412076 +5845 4 5.18955 1.04652 26.7639 -2.94161 4.65408 6.15856 +5846 4 5.65876 1.67721 28.1054 -5.69693 -0.488114 1.02013 +5847 6 43.5905 24.3648 30.2005 -22.2044 -15.6763 19.9702 +5848 4 44.3573 23.9419 29.8442 19.8319 -9.6252 -11.3654 +5849 4 42.9995 23.6287 30.4468 4.54232 11.3491 -5.57307 +5850 6 33.7546 3.53169 22.9281 6.20171 -10.3572 -20.5792 +5851 4 34.1788 2.72522 22.5548 -7.61164 22.2296 6.95503 +5852 4 33.66 4.19918 22.2026 -0.715781 -19.232 19.3758 +5853 6 19.8847 13.4579 25.4063 -13.0952 -9.58357 -31.6265 +5854 4 20.5464 14.0819 25.6574 14.0517 10.8301 14.4774 +5855 4 19.8633 12.7253 26.0209 8.35596 -5.88238 10.9252 +5856 6 47.3765 23.175 39.6238 -8.62258 12.6683 8.16714 +5857 4 47.7656 22.5263 39.0394 4.03481 -11.1372 -12.2265 +5858 4 47.7314 24.026 39.3382 2.38196 -1.35255 2.76448 +5859 6 20.1792 18.6695 32.3892 10.8118 -11.8558 9.82813 +5860 4 19.7451 19.3837 31.9609 -18.6549 15.8768 -14.4176 +5861 4 21.1063 18.8885 32.2904 5.57481 -8.22146 4.6255 +5862 6 0.469489 5.80056 25.6694 -18.1951 25.8664 -34.3154 +5863 4 0.192512 6.63022 25.2132 12.4788 -26.9708 -4.90825 +5864 4 0.599388 6.15564 26.5295 8.98284 3.20038 34.2611 +5865 6 6.87796 19.5502 31.9212 -30.9469 28.3562 -15.4034 +5866 4 6.36899 19.9719 32.666 7.94508 -11.3044 -26.1662 +5867 4 6.51823 19.9652 31.058 21.1032 -17.2362 32.6466 +5868 6 6.72006 20.2763 38.5282 -5.5716 11.964 -18.9783 +5869 4 5.89143 20.7831 38.5761 11.8801 -4.42879 -4.55199 +5870 4 6.91977 20.0675 39.4366 -2.33705 -6.77268 4.9945 +5871 6 22.0131 25.9408 12.2669 -3.54377 -45.9259 -44.7125 +5872 4 21.4169 25.4251 11.6232 6.06411 36.0021 36.1209 +5873 4 22.8575 25.5519 12.0003 5.79029 4.70211 8.19546 +5874 6 39.2956 7.94468 2.64777 3.93347 -3.54621 1.69719 +5875 4 39.6192 7.96721 3.55942 2.89932 9.4301 1.57912 +5876 4 39.5223 7.0665 2.33247 5.57505 -8.53159 -3.65477 +5877 6 29.9733 22.0379 34.4029 6.80249 8.99144 -26.5663 +5878 4 30.9486 21.9114 34.4332 -22.6925 2.47334 -4.63229 +5879 4 29.7282 22.2324 33.4511 1.23467 -5.29722 31.1857 +5880 6 37.585 16.2896 0.378862 9.66072 -32.1652 -13.4334 +5881 4 37.1738 15.3958 0.469359 7.4986 19.6703 2.82788 +5882 4 38.3979 16.0784 41.7811 -5.81955 5.34443 7.8674 +5883 6 11.7199 13.8969 21.9024 0.976022 -4.28814 -52.9061 +5884 4 11.762 13.5091 20.9636 8.25344 3.74313 41.2159 +5885 4 11.7301 13.2111 22.5694 -0.197866 -18.3587 0.721586 +5886 6 33.3547 10.9227 27.6206 7.79028 2.98821 -12.2755 +5887 4 32.7398 11.5851 27.2614 8.9286 -8.03905 3.2582 +5888 4 34.0693 10.7866 26.9485 -19.1033 10.7299 13.3482 +5889 6 30.9479 36.5351 10.0985 1.61282 -58.9885 -21.8283 +5890 4 31.0506 36.3975 9.1055 -4.33965 11.8991 35.1417 +5891 4 31.0192 35.5887 10.4601 -6.41155 39.3119 -7.26857 +5892 6 45.5784 6.55949 25.24 49.1938 -13.828 -6.30557 +5893 4 44.6777 6.5515 25.5065 -25.461 -8.09624 7.65514 +5894 4 45.978 5.64009 25.2752 -26.9592 28.1751 -0.0529727 +5895 6 9.53089 30.0259 12.0468 18.203 -29.4993 -35.3826 +5896 4 9.87965 30.5113 11.2809 1.8895 2.86193 6.03312 +5897 4 9.26134 30.6784 12.652 -18.7794 25.6859 27.1844 +5898 6 53.0787 24.9761 1.37462 5.70131 11.5656 52.3682 +5899 4 52.7701 24.171 1.02302 -14.9871 -27.078 -25.8882 +5900 4 53.2426 25.5756 0.676612 4.18045 17.0305 -26.7636 +5901 6 26.1794 24.7359 0.502901 22.1176 -25.6344 -30.1555 +5902 4 25.7034 24.7594 41.5454 1.42755 5.35042 26.0986 +5903 4 25.8798 25.3805 1.12222 -18.0425 21.9232 11.274 +5904 6 23.006 2.41877 11.549 3.03835 0.786733 -23.201 +5905 4 22.1232 2.19651 11.8728 1.75899 -1.65202 1.96434 +5906 4 22.9163 2.42328 10.5701 -3.31062 2.24291 13.1011 +5907 6 29.9286 12.8953 30.9894 2.56623 -0.427284 6.89615 +5908 4 30.7531 12.7948 31.5295 -11.6926 9.48208 -25.7239 +5909 4 30.1452 13.1242 30.0532 3.97045 -7.90132 21.6369 +5910 6 24.0654 16.1863 40.3478 -8.57837 -16.1993 -7.0618 +5911 4 23.8181 16.8167 40.9886 -17.7345 17.1107 43.7161 +5912 4 24.4461 16.799 39.7307 8.03288 -6.21636 -19.956 +5913 6 21.8775 29.9129 12.7438 8.38993 20.3936 0.69825 +5914 4 21.1101 29.6022 12.2761 -16.411 -9.00989 -4.05561 +5915 4 21.7959 30.8814 12.6689 6.66677 -10.3308 5.74649 +5916 6 45.2196 12.276 6.62528 -23.2047 44.1078 30.1736 +5917 4 45.4494 11.529 6.11864 16.0879 -27.9404 -20.133 +5918 4 45.9267 12.944 6.63915 -2.18395 -9.27911 -10.7446 +5919 6 7.59043 25.3914 38.0243 42.7544 -18.087 21.3587 +5920 4 8.2454 25.1294 37.3073 -28.6085 13.3538 22.5553 +5921 4 8.06078 25.1795 38.9036 -17.5445 13.8955 -36.9473 +5922 6 46.1702 7.81994 16.6869 -21.8749 40.0263 -11.2018 +5923 4 46.5308 7.86296 15.7811 2.96678 -6.7279 9.6444 +5924 4 46.6568 7.20863 17.2067 24.29 -27.7199 6.2944 +5925 6 54.9712 12.8519 7.72645 -5.0392 -7.84126 -11.592 +5926 4 54.9715 13.8156 7.65436 -3.45199 -1.13943 9.08655 +5927 4 54.3111 12.5688 8.37934 8.51313 12.0297 -0.864167 +5928 6 26.936 39.6495 37.1759 1.87165 14.912 18.6021 +5929 4 27.6928 39.6002 36.5592 -3.34619 -10.0228 14.3716 +5930 4 27.1866 39.3914 38.108 -0.832196 -0.678219 -33.4669 +5931 6 27.0349 8.92218 38.0169 24.6524 -2.61622 -28.7715 +5932 4 26.316 9.52058 38.1337 -23.9094 17.4181 8.51603 +5933 4 27.4852 9.31616 37.2255 -4.7843 -14.0734 18.554 +5934 6 8.05135 7.65161 29.9116 12.1299 -7.94147 21.2544 +5935 4 8.62851 7.92802 30.6495 -6.35395 -5.29094 -12.0163 +5936 4 7.74814 8.47335 29.5547 -5.2558 18.4649 -14.2469 +5937 6 27.8737 27.8565 12.1051 -38.6038 15.3188 22.9885 +5938 4 27.4445 28.7122 12.3849 14.7215 -19.9621 -4.23437 +5939 4 28.6312 28.0341 11.5799 28.6137 10.9177 -18.1106 +5940 6 23.5548 30.5037 38.1558 -29.4871 -31.9475 26.5081 +5941 4 24.0962 30.758 38.9126 3.93335 7.76671 -5.43794 +5942 4 23.9417 30.8351 37.3772 21.2145 16.4773 -23.4003 +5943 6 48.0793 24.306 17.3344 -19.3615 12.8085 -14.3801 +5944 4 47.2872 24.7421 17.7455 27.359 -7.68532 -3.4425 +5945 4 48.1537 24.7387 16.4546 -0.580236 -6.90317 13.1114 +5946 6 38.498 5.30294 40.3305 40.7021 23.5094 2.62433 +5947 4 38.9475 4.64687 39.7972 -10.9193 -18.4764 2.07144 +5948 4 39.1882 6.01706 40.3225 -28.8653 -3.92995 8.38836 +5949 6 31.2337 3.92695 33.7301 -2.6422 16.6026 -6.87478 +5950 4 31.7948 4.28658 33.0166 -2.97898 -8.44373 7.32517 +5951 4 31.5298 3.03423 33.9266 10.3473 -9.06319 -0.444766 +5952 6 41.2426 8.81864 38.1104 -4.47266 -7.82466 24.3448 +5953 4 41.0373 8.41451 38.9755 -2.01902 1.52645 -10.1427 +5954 4 41.1368 9.75783 38.3095 7.23604 3.04516 -5.74389 +5955 6 53.3619 29.0937 24.5785 -40.2757 11.297 7.14485 +5956 4 52.5565 28.5537 24.7901 26.871 10.2044 -0.818821 +5957 4 52.9453 29.9599 24.3491 20.4755 -15.9472 -3.03 +5958 6 54.9044 15.544 40.7081 25.545 -57.3548 17.1629 +5959 4 54.9892 16.405 40.3633 -12.4948 43.2864 -12.4113 +5960 4 54.018 15.2891 40.9908 -7.57666 14.2468 -5.0348 +5961 6 46.3994 17.0672 31.8767 -6.245 16.1286 -17.5712 +5962 4 46.5114 17.9797 31.5283 3.34232 -11.2714 9.55259 +5963 4 45.8128 16.6602 31.1996 2.74349 5.02824 21.6551 +5964 6 36.898 25.0477 23.0493 11.3229 21.4084 -39.4528 +5965 4 37.2029 24.9737 23.9235 7.13326 -1.42781 43.2733 +5966 4 36.3025 24.3424 22.8486 -15.8402 -9.5757 6.36085 +5967 6 11.3692 4.41343 15.9249 15.7896 22.4119 -17.7964 +5968 4 11.3725 3.62473 15.3598 -3.28732 1.6252 14.2587 +5969 4 11.7055 5.11941 15.3214 -6.01385 -9.48847 12.8461 +5970 6 12.7845 7.07125 19.464 -10.6801 6.56169 22.7508 +5971 4 12.8604 6.27981 18.9655 14.1597 -21.8558 -24.6024 +5972 4 12.2771 6.71627 20.2197 6.8185 19.6013 -8.61559 +5973 6 12.0681 33.6471 17.5522 -1.52085 -17.496 -42.1785 +5974 4 11.9445 34.1189 18.3508 -6.25092 12.897 34.2466 +5975 4 12.5251 32.8183 17.7704 2.9394 6.95993 4.68875 +5976 6 10.2419 4.74292 2.55933 22.7613 10.361 1.71337 +5977 4 9.42389 4.50476 2.9876 -9.73314 -9.75152 7.74431 +5978 4 10.9687 4.12007 2.82053 -14.8261 2.90481 -11.2179 +5979 6 4.58785 36.8771 12.1606 -7.79451 -50.5455 -28.0593 +5980 4 4.4315 37.6675 12.6216 -0.588552 45.9766 17.7929 +5981 4 5.40236 36.9214 11.6472 0.781205 5.58305 7.99313 +5982 6 30.7591 35.3322 25.8391 -38.6972 -6.70904 -25.8809 +5983 4 31.308 35.3014 26.6139 2.09136 -3.6723 11.5509 +5984 4 29.8922 34.8696 26.0006 25.0535 4.09477 3.57125 +5985 6 20.1826 7.15897 1.87495 42.3449 13.1453 -15.8992 +5986 4 20.9155 6.54161 2.14653 -26.0098 16.5163 -6.36728 +5987 4 20.7109 7.92751 1.4772 -24.8109 -25.5601 12.7141 +5988 6 21.7554 6.89613 28.9929 -8.55274 -2.37394 -9.1913 +5989 4 22.0764 7.2366 29.8207 3.60587 3.07422 19.5812 +5990 4 22.5251 6.52709 28.5653 7.82832 -0.878326 -6.51175 +5991 6 6.87782 37.1389 6.94163 -1.13334 10.8563 13.3375 +5992 4 7.36847 37.9928 6.7949 -15.2779 -15.8129 7.53623 +5993 4 6.56156 37.0941 7.87645 12.8328 8.43507 -22.3513 +5994 6 37.1951 18.3599 16.3051 31.8484 54.3956 -63.0636 +5995 4 36.5686 18.6502 16.9278 -28.3708 4.63663 38.6073 +5996 4 37.3394 19.2548 15.8115 -3.93301 -42.965 18.1753 +5997 6 52.3874 25.498 31.3134 14.111 8.09505 3.74503 +5998 4 52.2596 26.4307 31.6656 16.8187 -33.1452 -9.3176 +5999 4 53.3531 25.244 31.2999 -24.6813 13.8962 6.4969 +6000 6 3.93514 39.8328 16.38 27.5969 -10.0907 -6.6773 +6001 4 3.11618 39.8354 16.8714 -5.56329 -11.6849 3.14974 +6002 4 4.25813 38.8985 16.2148 -16.7217 35.1377 3.93655 +6003 6 26.055 14.6352 18.3097 2.48745 23.0231 -5.4837 +6004 4 27.0121 14.5315 18.422 -4.58232 5.3017 0.111087 +6005 4 25.8831 15.6122 18.2324 0.591934 -25.1482 1.36918 +6006 6 22.1861 39.625 23.6336 -13.0035 -7.16992 22.0669 +6007 4 22.5756 40.4198 23.3178 20.0241 20.7615 -16.9022 +6008 4 21.775 39.9577 24.4575 2.36146 -17.5943 -7.81238 +6009 6 5.9827 12.8747 22.3739 5.28791 3.19174 -0.347139 +6010 4 6.16079 13.1981 21.4813 -0.557605 -0.80783 -0.954564 +6011 4 6.85402 12.6686 22.7296 5.64669 -4.60509 -1.11135 +6012 6 48.9358 28.1656 34.7093 -34.12 -15.1013 -7.57113 +6013 4 48.3009 27.4712 34.4428 -1.24475 21.7165 7.07681 +6014 4 49.7483 27.6911 34.6564 33.1581 1.27133 3.59264 +6015 6 7.76665 22.4378 33.2356 5.82113 4.36953 2.134 +6016 4 7.99414 22.0593 34.0982 -2.05459 -3.4103 -7.93698 +6017 4 7.15982 21.8587 32.7652 -2.05153 -2.03416 7.79212 +6018 6 41.0903 39.5994 11.7192 28.8485 25.6095 5.96672 +6019 4 40.6961 40.3697 11.3388 -29.9964 5.48828 -17.7316 +6020 4 41.854 40.0697 12.1081 -2.33823 -21.5528 5.66509 +6021 6 26.8801 37.922 39.3457 -9.67122 -13.15 30.7983 +6022 4 27.1418 37.9976 40.2903 -3.7646 7.48977 -14.0985 +6023 4 25.9915 37.5069 39.4007 11.6973 7.1772 -10.1587 +6024 6 16.8317 41.5399 16.7862 15.0313 6.40425 17.7164 +6025 4 17.5506 0.178386 16.4567 -5.24562 -1.69226 -13.3924 +6026 4 17.0965 41.4441 17.7156 -14.9292 -9.12078 -7.2801 +6027 6 19.02 8.9948 17.6728 1.01249 -20.0254 27.6053 +6028 4 18.8256 9.92734 17.8397 -2.50665 -0.780218 3.94781 +6029 4 19.0722 8.45531 18.5284 1.63313 22.2167 -34.6872 +6030 6 31.0993 24.379 20.1031 -5.45136 7.30173 -0.0135243 +6031 4 30.58 24.6604 20.88 7.69136 -4.59203 -13.2888 +6032 4 31.7465 25.0718 19.9526 0.652083 2.88804 -0.364555 +6033 6 24.6121 6.3117 27.596 -14.2942 3.47042 8.51555 +6034 4 24.6855 6.72112 26.7154 0.000835906 -11.6728 3.52597 +6035 4 24.4562 5.35726 27.5796 2.29956 0.742888 -9.80031 +6036 6 11.6309 5.33579 8.21245 48.3472 17.5789 -13.0214 +6037 4 10.7447 5.097 8.35577 -43.9811 -8.24091 9.59422 +6038 4 11.6324 6.14291 7.66014 -5.62825 -15.0071 6.92232 +6039 6 16.4828 34.2339 17.2467 58.9453 43.3211 -11.1422 +6040 4 15.833 34.737 16.7643 -22.9367 -4.06405 -2.05249 +6041 4 17.323 34.8225 17.0684 -41.083 -49.3458 15.3182 +6042 6 40.7431 40.4645 8.52128 12.2314 -11.8005 -21.5431 +6043 4 40.0246 40.6751 9.09883 -14.9736 5.2464 12.3608 +6044 4 40.4244 39.6664 8.05294 5.87539 10.603 6.78918 +6045 6 42.7463 5.87875 14.2877 12.74 -3.29305 -3.26541 +6046 4 42.0588 5.87807 14.9272 -15.1719 8.11415 20.4154 +6047 4 42.5132 5.11812 13.7588 -0.0411089 -3.23222 -11.0769 +6048 6 14.3659 21.065 6.06718 -46.5802 14.1632 25.7131 +6049 4 14.5381 21.6726 6.80844 -4.55135 -9.99097 -5.53618 +6050 4 15.2049 20.8313 5.76105 45.2018 -10.2131 -22.6687 +6051 6 16.2987 37.772 18.1217 -43.41 26.7654 24.2454 +6052 4 15.4242 38.2299 18.3727 36.2216 -25.3097 -28.3843 +6053 4 16.6845 37.7048 19.001 13.5629 -5.49997 -6.41318 +6054 6 40.7915 27.7152 27.1158 9.45156 2.81801 -4.91689 +6055 4 41.5456 27.319 27.566 -3.53201 -5.16081 10.0516 +6056 4 41.2155 28.2976 26.4751 -4.07016 3.79859 -1.40954 +6057 6 44.9595 25.9846 14.0499 3.3218 -15.4841 -8.79479 +6058 4 45.329 25.1566 13.6433 -5.22711 26.2877 13.1546 +6059 4 45.4837 26.7406 13.7529 4.37393 -9.76715 -6.45081 +6060 6 2.62066 33.9505 21.2427 -16.9582 -3.86849 -3.69815 +6061 4 2.06211 34.7496 21.3041 9.37305 -3.74186 4.79914 +6062 4 2.1388 33.3568 20.6382 5.47892 10.3925 4.65279 +6063 6 5.77806 4.43691 12.8378 4.70319 28.9306 -8.8144 +6064 4 5.36233 3.72198 13.3221 -5.81749 -8.58488 4.20714 +6065 4 5.80863 5.24637 13.3804 -1.3041 -13.5761 2.8333 +6066 6 16.8665 5.92021 7.40582 23.56 -3.08178 3.03829 +6067 4 16.4354 5.08697 7.20958 -2.89912 -12.7512 -7.28137 +6068 4 16.1638 6.54304 7.4701 -21.737 13.5702 4.65232 +6069 6 17.8259 38.4084 36.8446 -8.45971 28.6621 19.1884 +6070 4 17.7005 39.3712 37.0468 11.155 -18.7052 -15.1769 +6071 4 18.5325 38.3077 36.2071 4.43545 2.51623 -4.89916 +6072 6 43.3084 20.5973 5.4325 -39.7754 20.35 -2.23031 +6073 4 43.0204 21.5105 5.15286 19.9417 -23.843 3.70329 +6074 4 42.4274 20.1471 5.43024 22.0601 -2.53082 1.71294 +6075 6 21.5318 23.3 30.4444 10.3709 20.0389 -42.3415 +6076 4 21.0369 22.9394 31.1576 -20.9289 -4.03021 22.2109 +6077 4 20.911 23.6578 29.7428 10.7798 -15.246 22.7192 +6078 6 0.249866 28.0345 36.1724 -10.1983 37.6035 -27.6546 +6079 4 1.05324 27.7572 36.576 20.3102 -14.8665 16.9966 +6080 4 0.540234 28.832 35.6712 -10.982 -12.5736 6.41543 +6081 6 3.04754 17.0516 11.5683 -6.97145 7.64509 -15.3824 +6082 4 3.16434 17.3061 12.4746 3.36597 -0.550097 20.9912 +6083 4 2.52404 17.7798 11.2137 2.91457 -3.72579 -4.7217 +6084 6 24.1788 37.0366 23.9551 -12.9856 4.64226 12.2764 +6085 4 23.6099 37.826 23.831 6.85326 -8.75197 5.00341 +6086 4 24.4012 36.9865 24.9175 -1.53567 3.17074 -21.6248 +6087 6 3.95494 20.5134 27.4915 2.8093 53.7214 17.1103 +6088 4 3.58105 20.0931 26.7551 -14.7022 -26.8908 -38.8522 +6089 4 3.8118 21.4686 27.2477 5.25372 -20.6261 11.8203 +6090 6 54.8404 2.77723 29.6182 19.2518 19.5174 31.7291 +6091 4 54.8688 2.43537 30.559 -2.71579 12.5717 -24.6672 +6092 4 0.596183 3.44189 29.5911 -17.1059 -25.2514 0.407437 +6093 6 27.1931 8.41834 31.7378 -5.45838 77.4793 -29.1542 +6094 4 26.7872 8.25949 30.8671 -2.01983 -12.8877 1.93898 +6095 4 27.4107 9.43311 31.6496 -7.24897 -56.0438 21.5563 +6096 6 30.967 1.65521 30.3853 -24.4372 0.252197 19.6085 +6097 4 30.699 0.824835 30.0215 -2.04196 -23.8902 -26.6583 +6098 4 30.1085 1.94064 30.7387 6.28416 6.26069 6.0985 +6099 6 26.4053 36.4472 36.8445 23.7132 4.61357 6.55265 +6100 4 26.2095 35.8808 36.1068 -5.45287 -5.64468 -12.8873 +6101 4 27.3732 36.593 36.8324 -14.4493 2.44748 -3.93886 +6102 6 51.2993 10.0458 21.7014 24.6671 -30.2423 2.93053 +6103 4 50.7417 9.318 22.0589 9.26734 22.884 -6.07289 +6104 4 52.1551 9.59094 21.4448 -31.6711 18.7199 5.84467 +6105 6 52.4308 12.3792 23.2584 -6.42579 27.1004 22.8118 +6106 4 51.6946 13.0394 23.3088 16.6887 -7.91574 -6.77392 +6107 4 52.0327 11.5757 22.9611 -11.4365 -20.1199 -14.9439 +6108 6 9.99751 38.3699 20.6117 28.0449 -1.18219 -11.795 +6109 4 9.42862 38.2366 21.3654 -6.81781 0.619005 12.6857 +6110 4 10.9196 38.1916 20.8926 -11.789 -1.89114 -3.31064 +6111 6 22.7111 33.2651 0.632604 -8.26324 25.0772 17.5737 +6112 4 23.6702 33.3984 0.628432 0.752102 -10.2993 -4.51528 +6113 4 22.4939 32.4115 0.275412 2.14165 -18.6843 -11.1325 +6114 6 14.0859 40.8716 25.4956 -8.46488 1.55142 -11.4693 +6115 4 14.0599 40.7138 26.4427 12.1567 0.227551 5.06398 +6116 4 13.2623 40.45 25.1949 6.8133 8.32038 -2.55804 +6117 6 42.7734 15.0947 14.9538 14.4784 5.50426 -3.8277 +6118 4 43.0583 15.7694 14.2817 -8.42225 -24.0175 22.033 +6119 4 41.8405 15.2241 15.1238 -9.70916 3.613 0.791575 +6120 6 30.2327 7.231 8.54228 -3.22532 10.2874 -46.9304 +6121 4 30.2058 8.2102 8.45082 -0.363858 -13.9116 11.7844 +6122 4 30.4404 6.92219 9.39771 6.32383 2.81905 38.5597 +6123 6 3.37293 19.847 41.3038 28.0406 -0.792001 0.268463 +6124 4 3.19157 19.2836 40.5407 -0.0866071 4.98821 -2.30354 +6125 4 4.34764 20.0104 41.227 -24.6382 -4.50526 4.46777 +6126 6 8.87233 25.1482 17.2024 12.9182 -25.3276 -29.7935 +6127 4 8.99656 24.7585 16.2934 -10.9438 23.5455 20.5923 +6128 4 9.70028 24.8859 17.6216 -4.47076 0.166054 9.91948 +6129 6 9.34357 14.9539 22.0324 -26.1912 3.45279 3.87325 +6130 4 9.00509 14.8035 22.9321 4.97494 4.93375 -7.4516 +6131 4 10.1685 14.4775 21.9786 8.71262 0.391972 2.49596 +6132 6 2.03472 4.77693 20.8549 -5.0231 -16.4156 -4.2241 +6133 4 2.70086 5.4497 20.9192 18.9425 7.91266 2.94425 +6134 4 1.28907 5.15394 21.3146 -15.2358 3.90158 4.43282 +6135 6 18.286 7.04631 3.85489 -3.97091 0.415968 51.7005 +6136 4 18.7541 7.10917 3.04736 31.918 9.65669 -29.8899 +6137 4 18.8529 6.48913 4.44789 -12.6499 14.6692 -9.5202 +6138 6 17.0004 19.1661 19.8445 11.8294 -6.56912 -12.2376 +6139 4 17.7808 18.891 19.3473 0.445698 5.6808 3.33406 +6140 4 16.3387 18.5282 19.5337 -1.78106 12.0244 12.6463 +6141 6 4.30992 6.55322 21.357 27.1319 -4.11604 -15.0588 +6142 4 4.37542 6.91771 20.4543 -7.8574 5.76294 11.3657 +6143 4 5.24976 6.29093 21.5457 -28.1422 4.34799 0.417434 +6144 6 20.7778 36.9247 35.6618 12.7574 4.02765 2.49936 +6145 4 20.2864 37.0887 34.8562 -7.2468 0.0429553 -2.15645 +6146 4 20.2346 36.372 36.2389 -2.87094 1.27188 3.61263 +6147 6 4.73067 15.0203 31.2359 -10.2649 -12.7571 22.9725 +6148 4 4.37694 14.8342 32.1428 11.1861 -2.73027 -21.4712 +6149 4 4.72677 15.9733 31.1768 1.84417 11.2425 -7.2724 +6150 6 2.35535 1.23403 17.5726 17.2813 12.9738 -21.7174 +6151 4 3.03402 1.36527 16.8495 -17.2186 -13.1695 22.3246 +6152 4 1.92973 2.10387 17.6452 0.590267 -7.80147 9.6411 +6153 6 34.6252 31.5686 19.7984 -1.60729 -4.66139 0.568696 +6154 4 34.8929 31.9422 18.9439 4.49305 -5.18782 4.12596 +6155 4 34.4714 32.3271 20.3758 -2.9002 2.23803 -3.07041 +6156 6 24.1913 21.6089 13.5036 44.4004 0.328862 15.9674 +6157 4 25.0757 21.8297 13.9142 -30.8821 -6.11275 -18.7564 +6158 4 23.5519 22.0563 14.035 -11.4749 15.2668 7.23318 +6159 6 37.218 41.0972 5.69166 19.5034 -37.5651 -15.7416 +6160 4 37.88 41.7374 5.923 7.59407 13.6828 5.23653 +6161 4 36.3807 41.3769 5.99879 -24.6171 21.3167 5.70938 +6162 6 8.42841 7.99247 20.2345 27.9918 -33.0924 -23.0682 +6163 4 9.34968 8.06233 20.5347 -4.8675 5.92304 8.61954 +6164 4 7.93058 8.66586 20.633 -20.9635 39.4709 23.1164 +6165 6 14.934 18.8758 36.75 17.7625 18.3313 11.0559 +6166 4 14.0949 19.1945 36.41 0.856939 4.31409 -3.77921 +6167 4 15.6034 19.6084 36.7133 -18.5855 -12.9909 -4.44137 +6168 6 43.9791 40.6449 18.6524 7.41508 -0.428335 24.9958 +6169 4 43.9624 40.7544 17.7052 -3.16787 6.2189 -16.8328 +6170 4 44.8981 40.8188 18.9384 -9.62798 -9.77666 -5.30663 +6171 6 33.7986 32.259 37.3472 -15.5926 9.65631 -28.1821 +6172 4 34.0274 32.2295 36.4014 -5.19534 3.83485 15.8105 +6173 4 34.1945 31.4931 37.7276 18.2887 -12.3889 13.4194 +6174 6 5.09973 29.2834 24.0252 13.8314 -2.01249 29.2407 +6175 4 5.66693 29.5091 24.8044 -5.06459 -6.54793 -18.8628 +6176 4 4.76417 30.1245 23.7257 -5.49348 12.2693 -6.11875 +6177 6 33.6015 36.4179 10.971 30.294 2.53226 6.78363 +6178 4 32.7735 36.2836 10.5343 -15.5054 6.45725 -2.01925 +6179 4 33.4383 36.5424 11.9099 -7.56878 -2.98124 3.33663 +6180 6 28.3001 33.6166 13.1114 -3.16981 -41.1231 7.22112 +6181 4 27.986 33.7275 12.219 -4.10441 9.98298 -8.29397 +6182 4 28.0891 32.6746 13.2632 10.0083 14.4728 2.55385 +6183 6 6.1623 19.0624 24.2873 5.31394 -11.2621 -36.8053 +6184 4 5.95503 19.8074 24.8143 -4.51254 28.8134 22.7686 +6185 4 6.28788 18.3114 24.8476 4.1007 -18.6743 20.2695 +6186 6 28.4211 19.9362 1.86305 -4.43245 7.71948 8.08869 +6187 4 28.5604 19.4518 1.05094 6.94613 -11.0067 -8.65768 +6188 4 29.2593 20.0693 2.30859 5.46778 1.78077 -4.74455 +6189 6 42.0505 23.9714 9.55892 6.22877 26.0941 -5.00732 +6190 4 42.391 23.8165 10.4395 -2.03908 -8.00084 11.8727 +6191 4 41.7886 23.1541 9.15249 -7.7641 -22.6922 2.79783 +6192 6 43.5253 7.315 27.4414 4.48568 -18.9578 -0.168547 +6193 4 42.7359 7.07504 27.9388 -6.2009 1.74131 6.88183 +6194 4 43.2052 7.88335 26.7439 -2.31843 16.2411 -9.46916 +6195 6 20.4956 32.9945 9.25625 -63.2008 -2.41398 62.3431 +6196 4 19.7614 32.7323 9.96384 46.0698 -1.29529 -42.5223 +6197 4 20.3338 33.9485 9.24422 8.88758 3.29294 -12.4302 +6198 6 38.0318 35.2729 15.9427 -5.10059 -23.3836 -5.94715 +6199 4 37.3995 34.9842 15.2568 2.89047 3.01243 8.00796 +6200 4 37.9835 34.6007 16.6396 -2.13864 4.37071 -5.14357 +6201 6 47.5248 20.8808 3.95546 13.1177 31.1209 27.8573 +6202 4 48.0834 21.3954 3.36869 -6.69878 -8.89675 -13.1919 +6203 4 47.6052 21.4353 4.7772 -13.2785 -23.1226 -13.8569 +6204 6 10.9875 31.6892 41.4239 15.5099 5.40423 7.74084 +6205 4 11.658 31.8708 40.7529 -4.12469 -5.30401 -0.84079 +6206 4 10.1343 31.6927 40.9879 -7.96504 0.77506 -5.12071 +6207 6 43.245 12.6563 2.56138 15.9633 -17.8577 -2.60545 +6208 4 42.9226 12.9752 3.38765 -12.1061 12.2594 19.7928 +6209 4 43.9805 12.0851 2.8659 -6.2276 8.95994 -12.8364 +6210 6 49.4104 25.4124 21.1593 7.68799 -7.2912 5.83542 +6211 4 50.1422 25.2884 20.5387 -8.96396 0.548785 -4.3756 +6212 4 48.9554 24.5515 21.2297 -0.219253 8.20777 -2.75058 +6213 6 1.96484 34.1377 26.4635 6.42117 -7.58108 12.8955 +6214 4 2.78995 33.6488 26.6876 -20.6965 7.00883 -11.752 +6215 4 1.22498 33.5087 26.4121 8.61724 -1.18295 0.134997 +6216 6 17.1337 20.8362 36.6743 -37.6695 15.6036 21.8376 +6217 4 16.9634 21.7284 37.0778 2.65776 -21.0237 -14.9647 +6218 4 18.0617 20.7108 36.604 32.6572 -5.60583 -3.13187 +6219 6 36.5992 10.9735 3.70439 10.6975 8.82737 -5.2901 +6220 4 35.7369 11.4094 3.76988 -2.71865 -0.136466 14.5734 +6221 4 36.9547 10.7712 4.57736 -11.0261 -1.49358 9.11508 +6222 6 14.2213 20.6732 21.973 14.9521 39.3927 -42.8738 +6223 4 13.9206 20.2439 21.1689 -11.1282 -8.72354 1.45028 +6224 4 14.6851 21.4628 21.5779 -7.13343 -24.0966 22.8635 +6225 6 33.9052 12.2539 9.56536 64.6676 -19.1083 -72.943 +6226 4 34.3898 11.482 9.88615 -11.1791 5.59008 13.1859 +6227 4 33.2619 12.5422 10.1406 -48.1209 12.4396 55.8498 +6228 6 21.8075 41.4938 2.15247 -4.53434 0.170379 -15.7872 +6229 4 22.04 41.6038 1.2069 -3.47083 0.972349 16.0219 +6230 4 22.4007 40.8419 2.51679 12.4955 -1.6466 3.58022 +6231 6 20.9241 10.4413 14.2084 23.7182 11.537 17.3335 +6232 4 21.6155 10.8692 14.7979 -25.0251 -17.572 -17.464 +6233 4 20.772 9.54041 14.5736 6.4121 16.6732 -7.22543 +6234 6 6.25992 4.45494 24.6446 -20.993 10.5392 9.58783 +6235 4 6.70633 4.20365 23.8452 17.869 -10.7134 -15.0213 +6236 4 5.71116 3.71075 24.9084 -2.77077 -5.20552 -8.90983 +6237 6 50.776 14.5967 23.4784 31.7068 8.96229 10.5861 +6238 4 51.3012 15.0259 24.1918 -10.5702 -1.89466 -14.6802 +6239 4 49.902 14.4731 23.8252 -15.4415 -8.6063 7.51113 +6240 6 52.7906 13.9066 9.67243 -4.11462 48.2741 -4.64476 +6241 4 52.8606 13.0389 9.99278 3.823 -46.6932 12.5875 +6242 4 51.8698 14.0585 9.47707 -15.983 -0.946523 -10.048 +6243 6 9.04475 2.0467 29.9184 -38.5307 -30.621 -19.1189 +6244 4 9.46565 2.82007 30.2002 17.3321 39.2201 17.0183 +6245 4 8.08016 2.26538 29.8177 25.0495 -3.86709 2.38687 +6246 6 7.14389 29.9898 26.2407 4.70582 -42.771 12.4286 +6247 4 6.53112 30.404 26.8495 -5.08686 4.52864 3.1398 +6248 4 7.41427 29.1442 26.7142 -2.42767 26.6911 -17.7681 +6249 6 49.1638 41.7413 14.3375 -4.64089 27.4779 2.19815 +6250 4 49.5241 41.3828 13.5134 1.94418 -6.50091 1.47491 +6251 4 49.3811 0.802946 14.3236 2.14399 -30.2019 -5.07663 +6252 6 5.64888 3.82667 19.1906 -2.72189 -11.1411 26.1263 +6253 4 5.18678 3.36179 19.9258 5.23606 10.5823 -14.7259 +6254 4 5.05621 3.82399 18.4509 -7.60985 1.79477 -11.7277 +6255 6 9.32681 35.8274 24.8975 3.55565 13.5922 8.51546 +6256 4 10.2018 35.8152 24.4762 -3.06017 -4.39849 2.56743 +6257 4 9.46171 36.417 25.6586 -3.66837 1.49938 -3.23358 +6258 6 53.0285 29.7558 11.5499 -7.83487 -2.48558 9.64451 +6259 4 53.3653 30.4407 10.9686 7.5475 4.44921 -4.95089 +6260 4 52.7971 30.2083 12.3783 3.5824 -3.07517 -4.75195 +6261 6 22.6104 9.96627 5.67467 11.8622 1.90434 48.3765 +6262 4 23.3836 10.3266 6.15809 -8.36646 -10.9093 -7.81297 +6263 4 22.6398 10.3769 4.83333 -6.21393 7.91547 -32.804 +6264 6 39.5293 19.6134 2.67969 28.3515 9.20962 14.5311 +6265 4 38.5781 19.5068 2.58618 5.24604 -11.8744 -9.9137 +6266 4 40.0367 19.3939 1.87869 -17.6459 -1.04308 -3.70363 +6267 6 45.0742 35.5802 7.80399 12.9966 -1.00157 -13.6899 +6268 4 45.1073 36.2582 8.46111 4.45786 22.5875 10.9896 +6269 4 44.5296 34.9182 8.21469 -15.7495 -15.8794 0.100297 +6270 6 29.7829 14.2459 9.96531 -11.2509 -10.5838 -6.95263 +6271 4 30.0063 14.1556 9.0247 4.7074 -2.26926 1.20969 +6272 4 28.8478 13.9409 10.004 20.3358 11.6689 4.42407 +6273 6 29.2532 30.1489 21.8872 -22.7358 8.41186 19.7293 +6274 4 29.1261 30.8351 21.2312 3.02893 4.58934 -9.48892 +6275 4 30.0577 29.6729 21.7506 17.9631 -9.68935 -13.2514 +6276 6 11.1028 18.8149 6.56446 12.6172 11.1172 -5.75863 +6277 4 11.2898 19.7306 6.3073 -12.9819 2.38317 -1.53669 +6278 4 11.9922 18.4416 6.57196 0.724871 -8.7617 2.86424 +6279 6 13.403 39.1446 13.4748 19.5871 -11.9429 -30.0571 +6280 4 13.7697 39.8507 13.9939 7.8117 10.5151 13.4831 +6281 4 12.6292 38.8582 13.9386 -20.2152 -7.12839 8.32373 +6282 6 50.1432 12.9893 0.138872 33.4511 24.3017 64.4039 +6283 4 49.8497 12.6921 41.2405 -20.6967 -26.8999 -59.7452 +6284 4 50.7523 12.3231 0.503203 -9.52656 2.062 -3.94446 +6285 6 47.8312 31.3446 27.7846 -28.8076 12.8422 -13.2841 +6286 4 47.8833 31.94 28.5222 10.4006 4.03183 17.8143 +6287 4 46.9755 31.6479 27.4044 17.0933 -18.1054 -4.43643 +6288 6 27.7087 1.63781 7.50008 21.5285 -7.57238 -25.6841 +6289 4 26.9556 1.59549 8.05597 -25.0455 5.22958 17.9803 +6290 4 27.5166 0.963037 6.82134 -2.90509 7.89899 -0.0646572 +6291 6 54.8922 20.8 16.0331 4.1789 -41.4982 -7.93337 +6292 4 54.9282 20.9554 16.9716 0.186425 8.83729 15.9831 +6293 4 0.211633 19.8495 15.948 -9.91253 29.0383 -5.43741 +6294 6 37.4291 33.0056 34.4398 -14.0977 10.8622 -7.94924 +6295 4 37.2978 32.0826 34.6133 -1.58878 -21.6351 7.1631 +6296 4 36.5764 33.2755 34.0173 17.7258 4.45123 10.3439 +6297 6 19.5104 39.7742 6.7506 5.90241 -38.4201 -4.61078 +6298 4 19.1293 39.2182 6.01225 10.8403 19.9531 16.5545 +6299 4 19.9162 39.0938 7.35425 -12.9804 24.3225 -11.3083 +6300 6 32.4399 2.72699 8.06906 17.0773 23.4006 1.78158 +6301 4 32.9347 3.14941 8.81642 -19.9733 -16.2934 -9.37408 +6302 4 31.5531 2.49842 8.37658 0.516726 -6.41942 5.39598 +6303 6 12.9757 16.0915 4.06618 3.48233 -26.1302 -11.2272 +6304 4 12.5744 15.6527 4.83433 -0.695682 4.00385 -3.98901 +6305 4 13.3513 15.3473 3.55621 -4.30287 11.2057 5.6128 +6306 6 4.64677 29.9233 5.42983 -10.8182 14.2385 -56.8973 +6307 4 4.99957 30.1958 4.52107 -6.90737 -7.02982 36.161 +6308 4 3.86081 29.3683 5.18005 29.0195 11.7205 17.0104 +6309 6 29.7541 32.1122 24.0662 13.5325 13.0696 7.67536 +6310 4 30.657 32.2311 24.4313 -14.6232 -5.62961 -5.85099 +6311 4 29.8358 31.5529 23.3009 -2.99915 -14.1964 -7.88188 +6312 6 11.8689 30.6971 33.4711 -8.01032 -39.2081 28.7873 +6313 4 11.8961 29.8478 34.0479 -0.904256 41.1124 -29.4381 +6314 4 12.7288 30.7703 33.0546 6.62137 -3.78113 1.33903 +6315 6 17.3676 40.4123 27.3051 45.9752 30.8726 -27.1152 +6316 4 17.3095 41.3718 27.4557 -2.78012 -6.90788 -0.219066 +6317 4 16.6513 39.9873 27.6906 -54.0346 -15.2197 27.4879 +6318 6 8.66734 4.89901 8.93063 6.14116 -5.58058 -4.6479 +6319 4 8.35347 5.40804 8.18272 -1.2331 1.82325 -6.13974 +6320 4 8.16334 5.22925 9.67691 0.199365 1.34734 7.84993 +6321 6 39.5604 17.6833 9.57201 22.5105 -50.1639 -23.667 +6322 4 39.2658 17.6048 10.464 -10.5204 8.51393 23.2154 +6323 4 39.725 16.7168 9.31019 -10.6666 45.7312 -1.86495 +6324 6 31.4955 30.1755 28.5516 10.628 -19.507 17.1882 +6325 4 32.3525 30.3948 28.1778 -6.71462 8.32315 -8.11857 +6326 4 31.74 29.3729 29.0438 -14.9082 5.37925 -0.357203 +6327 6 52.6685 19.2672 40.0663 9.25056 16.4026 -20.0757 +6328 4 53.0106 18.7322 39.321 -9.61724 -4.6138 17.4516 +6329 4 53.0677 20.1385 39.8955 -5.74465 0.792691 -1.74468 +6330 6 3.24164 7.81666 9.85998 28.0429 9.66948 1.15728 +6331 4 3.83019 8.53432 10.2304 -23.9275 -17.8293 -12.7584 +6332 4 3.84853 7.29279 9.3074 -9.38214 5.4782 3.90821 +6333 6 23.129 35.218 35.5945 -25.4929 1.01472 15.9258 +6334 4 23.7784 35.3391 34.9359 33.2897 3.00284 -24.4901 +6335 4 22.5015 35.9398 35.4197 -4.85807 -5.03855 8.29984 +6336 6 19.51 14.0653 20.8221 -35.7596 -3.44758 -1.61502 +6337 4 19.8587 14.4985 21.6011 13.4146 6.44294 7.16022 +6338 4 18.5274 14.0852 20.9637 18.4505 -1.93413 -5.69736 +6339 6 23.6205 15.8624 24.0207 6.44012 -27.6666 -1.73497 +6340 4 23.7023 16.8084 24.0387 5.71305 22.1977 -2.17526 +6341 4 24.4604 15.4749 23.6823 -15.4387 15.2983 3.34328 +6342 6 0.280487 30.496 6.10097 2.10248 14.5258 38.6463 +6343 4 54.969 30.1752 5.28655 -5.78718 -18.1599 -43.8305 +6344 4 54.4568 30.8162 6.51538 2.11893 2.60892 6.09244 +6345 6 4.88818 13.213 29.1211 -10.1066 -44.834 -24.7823 +6346 4 4.81121 13.8494 29.7943 -5.77674 34.7781 35.8081 +6347 4 5.65875 13.4519 28.6173 14.302 5.76116 -10.624 +6348 6 54.2113 27.2762 19.1921 -15.5686 -30.3542 31.9917 +6349 4 0.068746 27.3681 19.6083 11.8738 0.793184 4.88761 +6350 4 54.2438 27.8077 18.4285 0.565084 22.1088 -37.313 +6351 6 13.9147 35.7477 9.19539 -9.45761 -42.0549 -30.4782 +6352 4 13.6498 35.0288 8.53341 12.0253 23.1831 27.3793 +6353 4 13.9217 36.5134 8.63033 3.91359 16.7787 -6.83247 +6354 6 5.91895 31.9062 18.8199 -10.5522 26.6577 -12.1166 +6355 4 5.59368 32.8276 18.7738 -3.70357 -9.82177 15.0022 +6356 4 6.3357 31.8271 17.9661 5.53766 -12.0386 -9.76018 +6357 6 5.80079 28.8629 9.48582 -4.23387 2.66619 -7.91216 +6358 4 5.1492 29.3316 10.0156 -4.194 3.81529 3.65919 +6359 4 5.26808 28.2356 8.96551 5.75879 5.11243 0.385299 +6360 6 40.1186 6.06288 9.7252 27.6823 -14.9678 -34.8134 +6361 4 40.0604 6.61837 8.91786 -4.97866 -6.72317 19.9534 +6362 4 40.8451 5.41953 9.46609 -26.5422 19.2978 14.9684 +6363 6 20.3249 13.4665 41.4109 48.5393 0.491453 -34.6424 +6364 4 21.248 13.7047 41.7262 -35.6043 -9.97545 -2.58991 +6365 4 20.4078 13.625 40.4256 -17.6073 -2.89865 23.6593 +6366 6 14.4355 21.7431 27.3521 26.8888 -5.93952 12.1752 +6367 4 15.3929 21.7238 27.5426 -15.4302 4.65814 3.66232 +6368 4 14.4086 21.5632 26.4128 -6.38145 3.02673 -3.91912 +6369 6 38.7552 1.80385 30.0529 11.0268 -28.3612 -27.359 +6370 4 38.4475 1.96331 30.9218 -11.1335 10.8767 32.3314 +6371 4 38.864 2.66369 29.6567 5.01485 14.1269 -3.82072 +6372 6 5.6038 10.8537 14.1812 -8.02182 -19.6512 10.0037 +6373 4 4.967 11.5707 14.1035 -3.71772 1.30399 -2.93081 +6374 4 5.11243 10.0991 14.6 11.6474 17.9462 -13.8385 +6375 6 45.4185 36.7135 27.9228 -18.8199 18.417 -42.2307 +6376 4 46.0687 36.7087 28.6222 8.21134 6.27257 3.16342 +6377 4 45.7172 37.2784 27.1471 -3.80026 -24.227 32.4306 +6378 6 54.0799 35.0377 20.3974 -0.144446 0.236923 -11.8112 +6379 4 53.8476 34.1116 20.536 0.519878 -4.41527 -2.37245 +6380 4 53.9532 35.2077 19.4441 0.866973 -0.817495 13.7238 +6381 6 42.0671 14.221 28.4749 -2.16655 -3.30611 3.54679 +6382 4 41.9442 13.9043 29.3971 9.00113 8.16851 -11.079 +6383 4 42.9986 14.4434 28.31 -2.56617 -4.72525 9.98454 +6384 6 34.845 7.68802 26.7053 1.50556 20.2543 7.34306 +6385 4 35.7046 7.39142 27.0344 -1.60005 -9.47728 3.59716 +6386 4 34.4934 7.05976 26.0702 4.4346 -10.8207 -3.70702 +6387 6 49.6605 30.7141 23.8514 -28.5275 -6.56067 -11.9374 +6388 4 50.4604 31.1934 23.8565 34.1351 17.5516 -0.640456 +6389 4 49.8146 29.9659 24.4072 5.37992 -19.8924 15.651 +6390 6 50.8948 7.80148 14.1671 21.5777 -12.9452 34.2787 +6391 4 50.8247 6.96775 13.7105 -4.99079 -12.0182 -18.7136 +6392 4 50.5655 8.51894 13.6572 -15.7049 17.9748 -24.3233 +6393 6 4.26893 39.4826 27.8512 8.9926 -8.51629 -1.47833 +6394 4 3.65831 40.2241 27.8513 -3.04259 7.34368 5.94949 +6395 4 4.00328 38.958 27.1013 -12.9816 -10.5728 -11.1653 +6396 6 8.75177 32.8341 8.22283 -21.5639 -30.1985 -34.1316 +6397 4 8.2383 32.1284 7.72694 10.6374 17.547 21.6449 +6398 4 8.83279 33.5372 7.56693 3.76401 9.53239 7.06969 +6399 6 52.9594 25.4882 9.38297 -25.0802 50.1357 20.0056 +6400 4 51.9882 25.4292 9.65119 35.7509 1.27265 -17.7678 +6401 4 53.158 26.4759 9.49827 -6.53976 -44.9947 -5.62964 +6402 6 29.5661 36.7256 19.4603 5.44621 -17.3757 32.4066 +6403 4 29.5786 37.3961 18.7906 9.88328 7.74732 -15.4263 +6404 4 30.4565 36.6309 19.8726 -14.3545 4.38723 -10.5986 +6405 6 52.3236 36.1013 25.1169 17.8415 -25.8683 -35.0149 +6406 4 52.9656 35.7372 25.71 20.0999 5.67458 7.00157 +6407 4 51.6595 36.4261 25.6714 -35.904 19.3861 23.0835 +6408 6 21.182 15.7103 31.1872 -18.8583 3.19523 -20.0756 +6409 4 20.6533 16.2005 30.5215 19.2403 -4.60119 13.454 +6410 4 20.518 15.2243 31.6931 2.46505 1.20146 2.10658 +6411 6 10.6569 22.4337 39.4531 2.51655 -26.4213 -37.4968 +6412 4 10.8327 22.4219 38.4645 -4.29248 9.16844 28.2769 +6413 4 10.2506 21.5589 39.6181 7.08653 12.2011 0.686531 +6414 6 25.1113 11.6729 22.7164 -12.9971 -0.576423 -18.0399 +6415 4 25.1382 11.4787 23.6279 21.2779 0.00518046 39.517 +6416 4 24.1824 11.5118 22.5586 2.84555 -0.272219 -17.8246 +6417 6 31.7896 10.4703 2.90217 -23.2712 -10.1944 -9.79051 +6418 4 32.6146 10.7499 3.28348 13.8778 6.97942 -8.99307 +6419 4 31.8394 10.4464 1.92418 10.0551 5.29594 18.2662 +6420 6 52.4849 36.4361 22.1663 -9.62786 -33.6069 5.21212 +6421 4 53.146 36.0606 21.5474 -12.5852 0.946736 4.3316 +6422 4 52.0694 35.6392 22.6209 17.7505 30.3514 -16.202 +6423 6 46.2093 40.0329 26.9877 0.0297183 29.9961 33.6049 +6424 4 46.4751 39.2742 26.5126 9.55695 -26.8643 -22.4205 +6425 4 45.9048 40.7092 26.3771 -3.76152 -2.91476 -3.34389 +6426 6 24.0885 36.7218 39.1011 7.12362 -3.16907 -4.80429 +6427 4 23.5999 35.9078 38.9667 11.8985 -11.6148 -5.9332 +6428 4 23.4559 37.2234 39.5891 -11.7402 16.6095 17.3029 +6429 6 22.3514 7.42547 31.8169 -35.2707 -41.8068 15.3628 +6430 4 22.2213 8.33277 32.0647 5.94025 21.3422 4.40196 +6431 4 21.6465 6.92073 32.3398 32.1745 21.6054 -24.7594 +6432 6 14.3502 18.3597 4.09728 -2.0055 -9.38358 23.348 +6433 4 14.1099 17.4219 3.93107 -0.92654 19.6042 10.3569 +6434 4 14.0726 18.5364 5.03654 13.0175 -10.3464 -23.9346 +6435 6 27.3175 38.46 0.124188 33.1007 -9.911 1.68747 +6436 4 26.9395 39.2806 0.463932 -4.88512 2.40457 5.81864 +6437 4 28.2608 38.413 0.45438 -35.2324 2.96259 -2.16122 +6438 6 18.6695 0.162292 12.2239 -43.166 1.81748 26.3235 +6439 4 17.7303 0.262878 12.5713 26.4571 2.30278 -22.2908 +6440 4 18.9433 41.3202 12.7499 8.63834 -11.46 6.42912 +6441 6 49.423 24.9792 25.3382 20.605 1.42964 -0.346179 +6442 4 48.5484 24.7002 25.6009 -12.613 -0.556076 -3.92373 +6443 4 49.3508 25.8032 24.8352 -9.8769 -5.62219 -3.2466 +6444 6 52.0685 20.2858 15.7446 -45.9435 -8.75518 14.7384 +6445 4 52.9731 20.5149 15.783 39.268 6.79994 2.42829 +6446 4 51.7449 20.2597 16.6676 4.81444 3.79951 -9.92674 +6447 6 49.6576 15.6472 38.4942 19.425 -17.6129 -0.00729052 +6448 4 49.2099 16.0165 37.7231 -6.98596 1.36616 -1.50856 +6449 4 49.5102 16.1958 39.2633 -14.7214 13.7889 5.58845 +6450 6 15.9211 23.7235 13.4193 23.3289 -36.8815 11.3263 +6451 4 16.506 23.7025 14.2147 -19.633 8.70021 -19.3267 +6452 4 15.5217 24.5725 13.2813 -7.62789 19.6624 11.7876 +6453 6 14.3566 29.1635 14.3074 -12.0826 22.9902 -11.8551 +6454 4 14.1263 29.6193 13.4563 6.10678 -19.1115 21.2229 +6455 4 14.1254 29.8374 14.9735 4.9154 -5.66101 -4.10969 +6456 6 30.4264 19.8612 16.8883 21.8822 -42.1222 -1.02119 +6457 4 30.7186 19.5182 17.7453 7.89699 4.38367 -1.56912 +6458 4 29.8579 20.5689 17.0557 -25.7709 36.069 4.20145 +6459 6 21.3137 21.0352 23.1207 17.1515 -0.95565 24.203 +6460 4 22.2175 21.149 23.495 -16.5785 2.35003 -9.75668 +6461 4 20.7278 21.0809 23.8918 1.9436 3.71589 -4.02445 +6462 6 32.3543 0.425745 25.2542 2.91189 -3.53517 -15.1456 +6463 4 32.2281 0.339162 24.2978 10.7775 -1.18886 4.59452 +6464 4 31.5305 0.792307 25.5362 -21.0885 6.89421 14.2132 +6465 6 26.144 32.4145 27.5224 1.5207 15.2147 0.716215 +6466 4 25.5792 33.1636 27.3089 1.00017 8.92672 2.49827 +6467 4 25.8737 31.7446 26.908 1.40169 -15.6227 -12.5261 +6468 6 31.6924 23.0038 41.4488 2.9891 4.25247 18.5975 +6469 4 32.5817 22.7219 41.7427 -10.6129 2.19465 -7.80737 +6470 4 31.0787 22.7203 0.234806 2.54762 2.31931 -6.22567 +6471 6 54.3675 17.8383 10.7129 6.79577 23.0573 52.4548 +6472 4 53.55 18.2477 10.4428 -14.1319 6.62767 -11.4304 +6473 4 54.6119 17.1874 10.0964 4.54612 -26.2874 -33.1105 +6474 6 15.4111 28.5567 8.624 -23.5209 17.7221 -14.2225 +6475 4 14.7074 29.0083 8.07604 23.4242 -18.2482 9.63627 +6476 4 15.9053 27.9212 8.07642 -10.4486 8.35345 -4.07335 +6477 6 21.923 22.3267 27.6697 4.39763 -15.072 3.90508 +6478 4 22.0757 23.261 27.7591 9.36727 14.8743 -6.39222 +6479 4 22.0153 22.013 28.5729 -4.02641 -8.91923 4.38679 +6480 6 2.936 17.0367 8.13301 26.8737 -0.816539 -9.93732 +6481 4 3.80704 17.1417 7.69888 -17.5309 -13.2134 -6.39661 +6482 4 2.90872 17.8246 8.6543 -8.08771 15.2208 15.3377 +6483 6 27.578 18.2783 3.98106 42.3665 -21.0645 -7.59535 +6484 4 26.9838 18.9866 3.87461 -35.9411 25.5305 -3.32845 +6485 4 28.3853 18.6252 3.56495 -11.0807 -10.9366 8.58166 +6486 6 24.7671 24.5333 8.4671 -3.55267 7.94183 -11.8318 +6487 4 25.0347 23.6359 8.24775 3.17664 -3.45343 1.13667 +6488 4 24.5725 24.5372 9.40731 3.34714 4.39373 0.466573 +6489 6 41.9868 30.4684 13.7801 28.6364 -21.7839 2.09937 +6490 4 42.9472 30.4515 13.6527 -5.43777 20.4489 -0.76134 +6491 4 41.8419 29.5153 13.705 -23.7897 6.87836 6.63004 +6492 6 15.6883 34.6775 41.5701 28.3539 0.757195 5.77675 +6493 4 16.4499 35.2822 41.5481 -1.40988 -1.74654 9.10263 +6494 4 14.9914 35.2483 41.869 -21.9895 7.57474 1.73196 +6495 6 11.1473 19.7636 40.5906 -7.01786 -3.24743 -12.0486 +6496 4 12.0915 19.8265 40.3679 -7.75233 -10.0339 3.8807 +6497 4 10.7912 18.9088 40.243 10.6872 10.1147 9.9033 +6498 6 47.4955 34.5311 14.2936 14.7321 -31.661 -1.66099 +6499 4 46.9342 35.3117 14.2317 -6.87541 2.2103 -19.2779 +6500 4 47.4978 33.9137 13.4978 -3.14061 27.4792 16.9676 +6501 6 12.3981 26.9866 28.4861 26.5251 -74.1409 -7.08463 +6502 4 13.226 26.8461 29.0045 -10.1246 11.0422 -0.548558 +6503 4 12.3843 26.0988 27.9797 -6.45597 45.1087 15.272 +6504 6 27.6352 16.207 39.8297 -11.2321 14.8168 6.13397 +6505 4 27.2166 15.4175 40.1567 -13.0977 -6.13948 14.8525 +6506 4 28.2209 15.8539 39.184 23.7477 -3.37658 -20.6816 +6507 6 33.4012 31.2187 27.2758 -9.34358 5.5086 -22.6345 +6508 4 34.125 31.7676 27.5967 0.31405 7.14405 -9.79506 +6509 4 32.8978 31.7031 26.5666 21.3968 -7.09575 17.214 +6510 6 39.0983 39.5786 31.9234 0.802497 -2.15341 -0.194752 +6511 4 38.8245 39.6381 30.9898 -0.836727 0.773065 10.2743 +6512 4 38.5517 40.2102 32.4207 8.13236 -5.11153 -2.10971 +6513 6 22.8875 16.5662 19.9556 -18.6429 -47.4181 0.677292 +6514 4 23.2714 15.7467 20.3471 4.73069 19.3315 1.98369 +6515 4 22.0725 16.1814 19.5628 10.6014 14.9969 -2.71875 +6516 6 23.9725 21.8734 10.5896 -27.2099 14.1239 -19.8382 +6517 4 22.9807 21.8764 10.5048 23.1264 -0.860286 11.7265 +6518 4 24.1883 21.166 11.1844 -1.51334 -13.3572 20.4185 +6519 6 40.1791 25.4384 2.79385 3.27033 10.4385 -27.7191 +6520 4 40.1215 24.9503 3.60378 -1.57927 -2.0951 21.761 +6521 4 39.8421 26.3422 2.89187 -4.34677 -6.39915 11.9951 +6522 6 15.0222 19.7637 9.4145 -47.1416 28.5942 15.5409 +6523 4 14.7277 20.7258 9.2944 13.9352 -33.0223 -5.4956 +6524 4 14.1981 19.3167 9.80349 37.3596 11.4933 -12.2096 +6525 6 7.16734 24.8761 0.122492 -38.9593 -14.3052 4.78001 +6526 4 7.92262 24.7355 41.4818 28.9246 2.82935 -8.29154 +6527 4 7.37325 25.3267 0.937782 12.1222 2.94845 5.10402 +6528 6 43.395 10.8961 31.3295 35.6095 27.14 14.9602 +6529 4 43.8689 11.0333 30.4778 -14.9331 -12.4968 13.4948 +6530 4 44.125 11.0026 32.0067 -24.5429 -5.74221 -22.764 +6531 6 13.8447 19.0699 27.8622 -3.35019 15.2359 -6.83255 +6532 4 12.9833 18.7163 28.0985 -4.55464 1.4506 5.93475 +6533 4 13.7874 20.0538 27.8435 3.60016 -14.5834 0.921784 +6534 6 3.48728 19.5892 9.61273 -55.7314 7.48447 -10.4955 +6535 4 2.69835 20.0905 9.96963 22.9021 -19.0673 -4.76373 +6536 4 4.2501 19.9102 10.0538 23.4289 5.03115 15.3445 +6537 6 51.0169 19.4212 7.7195 26.3048 39.1054 -53.7154 +6538 4 50.748 20.2575 7.21364 -2.7273 -32.3506 28.7892 +6539 4 51.8579 19.2204 7.21263 -29.2082 -7.0208 18.9647 +6540 6 42.2149 2.6091 10.4112 25.8935 -20.0624 -18.8025 +6541 4 43.1623 2.45904 10.6444 -24.152 11.2038 4.82319 +6542 4 42.1853 2.33112 9.4647 -3.80011 10.6068 21.7004 +6543 6 30.7928 6.43901 35.1986 -21.6247 -20.8821 1.11778 +6544 4 29.8295 6.39304 35.3716 10.0359 5.79706 -2.44011 +6545 4 31.0478 5.50645 35.0814 0.649811 9.90023 -1.69835 +6546 6 52.8722 36.96 18.5947 9.01539 9.27494 -7.55423 +6547 4 52.0657 36.4448 18.5061 -12.9065 3.13675 2.3407 +6548 4 52.6935 37.8522 18.2226 2.03776 -15.609 7.12003 +6549 6 44.2018 6.29599 1.04883 9.29405 17.1768 7.51252 +6550 4 44.5044 7.06671 1.58929 -4.49779 -17.4812 -0.431191 +6551 4 44.952 6.10526 0.487985 -0.115844 -2.61588 -3.46335 +6552 6 42.1326 38.6047 31.1849 18.5327 -13.3283 33.8135 +6553 4 41.7834 38.9864 30.4106 -14.9936 10.8543 -35.8121 +6554 4 41.4904 38.8324 31.8627 -0.641051 1.33351 1.93 +6555 6 43.7219 12.8013 9.05519 -6.282 7.91343 -40.7352 +6556 4 43.3171 13.69 8.87718 10.3632 -22.6116 8.3507 +6557 4 43.9578 12.415 8.15014 1.61383 14.3586 37.3488 +6558 6 13.4062 0.438838 6.51561 -30.6084 29.4042 -0.600484 +6559 4 12.9719 1.14899 7.05573 20.0807 -17.3818 -8.1595 +6560 4 13.3782 0.782754 5.59696 2.59294 -3.03922 8.63079 +6561 6 16.1217 13.2907 10.2805 -3.10591 -25.3511 -12.454 +6562 4 16.8946 12.7568 10.5076 8.02861 4.25978 2.86397 +6563 4 15.5299 12.6092 9.88546 -0.135156 17.9383 7.81515 +6564 6 1.59113 8.48217 4.69745 0.410151 -22.2633 16.3582 +6565 4 1.97054 9.1194 4.11301 8.92831 16.113 -22.7699 +6566 4 2.26765 8.43533 5.38895 -6.97239 3.0759 6.50405 +6567 6 37.2935 1.72102 10.5172 -13.7439 -9.21578 15.0824 +6568 4 37.1042 2.64553 10.595 10.0955 20.4226 -13.0857 +6569 4 36.8105 1.41855 11.2983 8.13599 -13.5394 -0.658926 +6570 6 53.8411 9.88961 17.6933 -45.7386 -38.9159 3.57486 +6571 4 54.5353 10.0399 17.0846 27.4782 6.59889 -23.5339 +6572 4 53.3721 9.08338 17.329 10.482 22.3983 14.0606 +6573 6 45.4787 30.6173 15.8038 -24.3966 -4.27047 13.1326 +6574 4 44.7717 31.1876 16.1963 22.3351 -9.42651 -10.1125 +6575 4 45.1907 29.6979 15.9324 6.84487 10.052 -2.21901 +6576 6 39.9241 16.6394 33.8426 -26.8877 -6.37158 -14.218 +6577 4 39.1549 17.2016 33.5476 23.291 -18.1751 3.42158 +6578 4 39.818 15.753 33.3934 2.94846 26.4583 15.0268 +6579 6 32.8532 24.7638 27.9368 9.55773 21.8346 -14.3088 +6580 4 33.6229 25.0593 28.4772 -14.6217 4.84572 -15.4057 +6581 4 32.6055 25.4822 27.2751 14.9958 -18.2832 35.5187 +6582 6 7.86628 31.6164 24.1091 22.2934 14.9204 62.1634 +6583 4 7.77595 30.8628 24.7489 -5.82572 16.0022 -25.8365 +6584 4 8.17309 32.3545 24.746 -24.9312 -26.1857 -42.8493 +6585 6 43.5324 41.3356 15.8165 16.5067 -5.02973 0.188395 +6586 4 43.1944 0.320073 15.7896 -5.69638 5.43212 -4.38793 +6587 4 44.429 41.3992 15.443 -10.6291 -2.88383 0.315207 +6588 6 20.021 29.5505 33.1902 25.0419 -7.98688 14.3875 +6589 4 20.8911 29.4069 33.5992 2.6372 -12.3274 -8.42754 +6590 4 19.6576 30.1636 33.8147 -14.9588 14.7065 -0.197692 +6591 6 43.4056 21.4569 18.6265 10.2156 -2.1017 15.5441 +6592 4 43.0498 21.3696 19.5313 -0.699705 -7.60676 -10.3888 +6593 4 42.9844 20.831 18.0298 -12.2248 -1.50447 0.773582 +6594 6 3.43117 19.1215 18.408 34.3393 4.70286 11.768 +6595 4 3.22621 20.0564 18.4267 -2.18643 4.81974 -5.59269 +6596 4 2.60088 18.6799 18.3703 -20.3233 -14.3491 -1.28903 +6597 6 41.6742 38.1112 16.3299 0.384784 -42.0766 -46.2559 +6598 4 41.8939 37.3404 15.6708 -9.75075 44.1094 34.3099 +6599 4 42.3403 38.1083 17.0131 5.25517 -2.87066 6.28124 +6600 6 7.56339 36.3915 10.5048 -18.8567 -13.4705 -13.5944 +6601 4 6.70677 36.1596 10.0967 9.18231 15.0261 0.193132 +6602 4 7.92251 35.493 10.5558 6.04756 10.3771 12.1048 +6603 6 36.2642 19.1103 34.8187 -40.4108 -29.7457 -43.4097 +6604 4 35.4719 19.3187 34.2477 20.3247 -4.92751 27.2967 +6605 4 36.4213 19.8813 35.3193 7.80254 33.8099 20.7293 +6606 6 53.576 24.9483 12.6399 1.20561 -0.517111 -17.326 +6607 4 53.6619 25.9414 12.669 8.79141 -29.2645 -7.24265 +6608 4 53.913 24.5623 11.7782 -4.09912 18.2899 28.1509 +6609 6 31.6824 10.4618 21.0892 -21.9557 -25.3726 -8.81809 +6610 4 31.4281 9.67391 21.5915 5.84781 10.5911 6.7189 +6611 4 30.8909 10.5838 20.5303 11.506 8.60894 0.332243 +6612 6 18.1093 28.7861 17.1823 13.2379 18.2354 -13.1758 +6613 4 19.074 28.7105 16.9739 -24.5165 5.38082 5.29014 +6614 4 17.7652 29.607 16.728 11.5472 -26.6353 13.0333 +6615 6 21.6834 18.2239 36.88 17.2587 0.811675 -5.67627 +6616 4 22.5671 18.027 36.4721 -27.7349 -1.55215 19.1593 +6617 4 21.6367 17.7543 37.7464 -1.70499 5.95625 -12.509 +6618 6 25.0551 19.0348 34.2287 -62.1041 -5.07763 23.2016 +6619 4 24.7663 18.3443 34.8719 5.43786 16.9757 -10.9409 +6620 4 25.8827 18.7578 33.9618 64.2031 -27.8273 -22.1538 +6621 6 15.5709 13.019 5.5539 0.00735057 -17.6807 20.5563 +6622 4 15.9927 13.3293 6.36292 0.0692085 12.4919 -5.39058 +6623 4 15.4491 12.0681 5.73828 -2.05735 13.2604 -17.7033 +6624 6 54.47 41.6402 14.7959 12.609 -13.6787 23.2741 +6625 4 54.8097 41.4531 15.6947 -1.45983 11.4249 -10.5768 +6626 4 53.7709 40.9948 14.7271 -15.6812 0.146288 -8.92901 +6627 6 1.6639 26.4809 31.3827 12.672 -25.15 69.1319 +6628 4 2.55491 26.3764 31.7735 -12.447 -0.333387 -5.00094 +6629 4 1.81595 26.6127 30.4938 10.6163 16.8649 -70.5286 +6630 6 32.3417 37.2868 29.6843 -28.8191 13.9029 5.49332 +6631 4 31.5776 37.8992 29.8843 22.0104 -18.6347 -4.04342 +6632 4 33.1171 37.6855 30.0945 4.79121 1.59444 1.77014 +6633 6 52.7104 21.0422 22.8867 -25.9211 15.4876 17.6965 +6634 4 51.8895 21.5407 22.5959 27.9099 -16.7396 2.24416 +6635 4 53.1785 20.6742 22.1421 1.33026 -7.16251 -14.9349 +6636 6 32.7465 28.5808 40.5193 19.5614 -2.95666 4.13778 +6637 4 32.1272 29.2507 40.2236 -19.1805 -2.02865 5.11045 +6638 4 32.5793 28.3106 41.4408 -7.78706 5.87783 -13.0149 +6639 6 23.6078 32.0654 16.3528 6.52471 10.7856 29.7964 +6640 4 24.3701 32.0729 16.9793 -11.8963 -10.2614 -20.8491 +6641 4 22.8856 32.382 16.9256 -1.99185 -7.37994 -15.8659 +6642 6 37.5296 9.17182 29.9714 -32.9897 5.30306 10.5453 +6643 4 36.7716 8.86544 30.5111 15.5785 -5.70066 -5.7121 +6644 4 37.1221 9.9689 29.5744 15.1662 -5.45151 -1.53858 +6645 6 2.26386 24.3835 14.5546 6.71022 -7.72281 -24.2479 +6646 4 1.85963 24.0133 15.3587 -6.19133 3.33276 -9.20692 +6647 4 2.05254 23.8227 13.7642 -0.610841 12.6744 29.5344 +6648 6 27.3686 28.7935 24.7702 8.50672 -13.2399 -34.495 +6649 4 27.2338 28.4442 25.6457 -6.20833 -8.14759 12.6395 +6650 4 27.3624 28.0447 24.1031 3.25167 21.2409 25.246 +6651 6 16.785 2.54959 14.3094 -6.20571 44.0359 18.8502 +6652 4 17.7332 2.53792 14.3228 12.8455 -14.2273 -3.64568 +6653 4 16.4133 1.8101 13.8617 -1.35631 -25.1723 -17.3636 +6654 6 21.8048 39.8028 36.8143 34.4281 41.1875 6.43987 +6655 4 22.7768 39.6281 36.9504 -24.2083 -5.20947 -5.56999 +6656 4 21.4132 39.0119 36.5213 -11.0202 -42.2818 -12.3994 +6657 6 14.0639 6.48367 41.5586 -1.33856 -25.5903 -39.7582 +6658 4 14.9412 6.10051 41.3922 2.86672 3.38346 15.7648 +6659 4 14.0719 7.05039 0.399753 4.3465 12.2327 22.8772 +6660 6 14.5548 16.5075 9.32956 22.0841 -14.7784 -21.2506 +6661 4 15.3586 16.5914 9.87503 -6.36199 2.72911 -6.08794 +6662 4 13.8899 17.0883 9.65711 -8.71884 14.1475 23.1102 +6663 6 8.67066 23.4815 30.5556 -44.0195 -7.59097 13.7496 +6664 4 9.49671 23.6557 30.1334 33.8338 1.75787 0.0184994 +6665 4 8.69311 23.4014 31.5307 16.0679 1.7618 -7.5699 +6666 6 37.6567 2.07706 19.9993 -10.7882 4.4912 14.9507 +6667 4 36.977 2.26584 19.3592 -1.31755 -8.36894 -24.369 +6668 4 37.311 2.65872 20.6865 17.7477 -2.01295 10.0374 +6669 6 42.7201 7.55732 8.02256 37.7013 -31.8103 68.6738 +6670 4 43.2078 7.90139 7.31041 13.9641 18.3531 -33.1003 +6671 4 43.4713 7.36984 8.74143 -54.3005 13.1784 -34.8973 +6672 6 38.5678 29.6657 6.85728 10.4727 -7.97498 12.0381 +6673 4 38.5138 29.2192 7.70857 5.95943 6.40388 2.63109 +6674 4 37.7242 29.471 6.47402 -15.8477 4.38345 -15.5494 +6675 6 42.5297 15.7017 39.7864 -1.2311 2.72873 2.24862 +6676 4 42.7877 16.6334 39.6476 -7.55712 -4.9727 -7.52807 +6677 4 42.0746 15.3358 38.9963 17.4435 12.5166 7.69263 +6678 6 19.8571 7.43592 22.0545 -24.1472 -5.51637 33.4113 +6679 4 19.2244 8.12179 21.7601 9.35088 -5.78158 -2.10146 +6680 4 19.4596 7.11536 22.9248 14.2781 17.6372 -34.9907 +6681 6 27.4149 3.22069 12.5516 40.9266 14.4549 -35.8463 +6682 4 28.3021 3.29229 12.0821 -30.0356 5.19144 18.8294 +6683 4 27.3767 2.28812 12.7581 -5.67627 -4.82192 6.74426 +6684 6 34.4116 6.50186 34.3661 -21.9879 -4.07114 7.78674 +6685 4 33.6675 7.13398 34.4265 8.52018 -4.33452 -1.60522 +6686 4 34.0848 5.70903 34.842 8.55338 12.1797 -0.556276 +6687 6 9.89342 27.9558 39.7643 36.6491 -8.46867 13.0669 +6688 4 10.8456 28.0225 40.104 -41.9626 -4.51635 -15.7261 +6689 4 9.67004 28.8098 39.3873 2.34979 10.3628 -2.65954 +6690 6 50.5619 22.115 6.39208 17.1303 26.4748 31.0688 +6691 4 51.4904 22.4109 6.45725 -8.74694 -11.3909 -7.00891 +6692 4 50.1939 22.6078 7.15954 -8.62199 -11.7106 -16.757 +6693 6 47.1151 11.4881 30.0373 19.0993 -20.4412 31.5796 +6694 4 47.2481 10.8506 30.7795 8.25865 21.4973 -13.9376 +6695 4 46.3269 11.1564 29.6474 -26.9131 -5.13028 -17.9745 +6696 6 25.9416 28.4741 9.79918 -11.6773 -32.55 32.2578 +6697 4 26.8348 28.2861 10.1548 -13.4597 2.20587 -7.83095 +6698 4 25.3328 27.8368 10.2912 20.3964 27.2145 -12.4741 +6699 6 35.4384 36.5941 19.4416 12.9267 19.1414 22.694 +6700 4 35.4164 36.6623 20.432 -0.885856 -8.21646 -20.3497 +6701 4 36.1159 37.2681 19.2232 -9.51806 -6.29836 -4.59986 +6702 6 39.0948 17.8654 12.2958 16.402 12.2899 -6.89152 +6703 4 39.0474 18.8007 12.5965 -2.38328 -10.6878 -1.40665 +6704 4 38.4419 17.3626 12.7715 -16.1853 0.319976 14.0097 +6705 6 2.67108 27.1436 2.40101 -1.75759 -3.65761 -8.1759 +6706 4 1.9876 27.5644 1.84788 8.2175 -2.76418 4.2561 +6707 4 2.53155 27.392 3.3289 1.87867 -1.67129 -3.85288 +6708 6 12.3359 32.2055 21.5153 -21.7508 0.12991 31.168 +6709 4 12.6488 32.0797 22.4173 29.0853 13.2861 -13.6486 +6710 4 11.491 31.8094 21.7155 -17.148 -0.720271 -25.2422 +6711 6 32.8833 32.3716 8.45599 -19.6455 -21.472 -14.5807 +6712 4 33.4538 32.8256 9.05859 9.48117 21.6574 11.6239 +6713 4 31.9723 32.7028 8.50155 9.17651 3.82723 3.41156 +6714 6 12.6485 6.44458 31.9777 -6.29944 1.49663 15.4125 +6715 4 13.1578 6.35833 31.1835 12.9638 -3.65534 -14.9347 +6716 4 11.7474 6.25334 31.7296 -4.07419 -1.29291 -2.47195 +6717 6 41.3645 27.7433 14.0415 -6.01814 -18.8263 -25.007 +6718 4 41.8124 27.3175 13.2596 -11.5333 15.588 22.1217 +6719 4 40.3975 27.5756 13.9407 20.5065 3.01622 5.4742 +6720 6 6.60161 16.499 25.4489 9.93734 -1.87947 -15.8553 +6721 4 7.35848 15.8951 25.4583 3.3895 5.33583 -1.00098 +6722 4 6.02379 16.0419 24.8253 -6.53341 1.34025 8.2366 +6723 6 21.7786 39.2974 13.3607 -58.7317 27.2846 42.4257 +6724 4 22.3848 39.3902 12.6828 41.4687 -6.70168 -50.5194 +6725 4 21.6228 40.2371 13.624 5.27297 -27.3266 2.34771 +6726 6 34.8408 6.01319 6.94562 -18.4641 -1.51643 5.78804 +6727 4 33.8445 5.90926 6.91888 31.3517 2.57767 -4.40922 +6728 4 35.1545 6.28252 6.0657 -8.54142 -2.93715 0.97402 +6729 6 33.0232 30.4151 33.1713 -30.7469 -3.39927 -39.9685 +6730 4 32.1382 30.6983 32.7963 25.7009 -18.3352 9.36685 +6731 4 33.1108 30.988 33.8978 7.7837 23.494 30.6115 +6732 6 15.4491 32.4129 12.2013 37.3068 -21.1945 16.3611 +6733 4 16.3823 32.073 12.2446 -28.3662 8.39135 1.47263 +6734 4 15.4224 32.8258 11.3561 0.313824 15.5191 -23.5701 +6735 6 12.6648 26.6033 21.3782 33.3074 -46.6123 -64.9668 +6736 4 12.0344 25.8976 21.5501 -12.6652 14.4466 17.403 +6737 4 12.7392 27.3327 21.935 -15.9008 39.2731 46.5109 +6738 6 47.0171 36.3051 29.9756 -14.9097 -3.99946 59.7783 +6739 4 47.3887 37.0247 30.5306 -0.120183 -5.44251 -19.0377 +6740 4 46.4147 35.8463 30.6463 22.302 11.6315 -30.1098 +6741 6 0.299553 12.7005 23.3858 -50.0817 10.3486 20.6993 +6742 4 0.55843 11.8154 23.133 6.9712 -0.709946 -9.28769 +6743 4 54.2783 12.6185 23.429 39.7411 7.62342 -2.706 +6744 6 54.1651 18.9185 21.5773 -27.3575 7.2555 -32.8787 +6745 4 0.055729 18.801 21.8215 42.2187 -10.4087 33.76 +6746 4 54.2632 18.7361 20.6344 -21.3012 2.13243 0.141772 +6747 6 25.7162 24.2884 23.7449 23.2111 -33.139 -2.25213 +6748 4 25.1836 23.5617 23.2944 18.61 24.747 21.927 +6749 4 26.5708 23.8587 24.0884 -36.4232 14.4676 -16.0896 +6750 6 11.8952 29.0236 26.8796 9.31073 -5.31833 9.58593 +6751 4 12.582 29.6684 27.1204 -3.01706 -1.21814 -5.31042 +6752 4 12.0145 28.319 27.5465 -5.16863 11.8863 -12.5997 +6753 6 48.0052 35.8598 10.6996 -18.0426 -22.591 -32.4945 +6754 4 48.7896 35.6794 10.1443 -7.64403 10.0758 9.7343 +6755 4 48.2747 36.3464 11.4544 19.4818 11.8303 20.3364 +6756 6 47.6544 29.8545 36.9555 47.7155 -39.8456 -42.9298 +6757 4 48.1196 29.373 36.1789 -16.9409 17.9192 43.9777 +6758 4 46.9556 30.2951 36.4995 -17.6283 12.0501 3.0439 +6759 6 7.32865 12.3513 10.6225 -20.3459 13.1064 -14.334 +6760 4 7.20572 12.8267 9.76478 7.03806 -14.4953 16.449 +6761 4 6.49136 12.5857 11.0944 24.1086 -12.0498 -8.15528 +6762 6 52.9256 15.9641 4.89737 -18.3283 -2.7411 -11.4996 +6763 4 53.001 16.1105 3.94443 2.36662 -0.713792 8.85774 +6764 4 53.8018 16.0105 5.25645 21.1817 2.44507 8.14275 +6765 6 10.6731 16.9472 34.6118 -36.7423 -4.99845 -47.4494 +6766 4 11.0533 16.8484 35.4724 -5.12202 -12.2675 26.0308 +6767 4 9.83371 16.4151 34.3796 40.245 18.7583 25.5995 +6768 6 25.147 31.0596 36.0152 -5.60145 -19.7687 -32.0201 +6769 4 25.7935 31.7656 36.1171 1.22463 2.78419 -3.72446 +6770 4 25.3418 30.5949 35.1615 -4.38154 15.6016 24.1358 +6771 6 34.0913 21.8858 41.4775 -4.76405 18.1665 32.5634 +6772 4 33.6625 21.1007 41.1787 -2.29922 -28.5955 -6.85504 +6773 4 34.6054 22.1733 40.7506 14.2114 10.2598 -30.2937 +6774 6 15.7731 30.0818 1.26798 39.0641 -13.3599 -49.0464 +6775 4 15.0823 30.4241 1.791 -23.818 19.5269 30.6537 +6776 4 16.2108 30.862 0.84325 -15.3415 -19.24 18.755 +6777 6 29.5302 27.8609 16.6022 -41.3972 -29.0796 28.0786 +6778 4 29.3307 26.8764 16.753 17.6765 42.2449 -1.67193 +6779 4 28.8227 28.3009 17.156 20.6394 -5.21731 -15.3441 +6780 6 39.6438 9.77612 0.552706 9.07327 13.2864 29.0584 +6781 4 40.129 10.5839 0.897097 -15.1313 -20.9808 -12.8857 +6782 4 39.4906 9.23066 1.36029 2.34479 9.54176 -15.0004 +6783 6 1.51524 31.8825 16.4089 -15.0842 0.567558 32.708 +6784 4 2.11225 32.2249 15.7721 17.5465 17.6302 -23.3114 +6785 4 1.56386 30.9485 16.2687 -0.663138 -25.5376 -6.36093 +6786 6 8.73078 39.8635 25.0545 2.96185 -34.7465 -17.9129 +6787 4 8.00321 39.5602 25.6169 4.07363 9.59654 5.53067 +6788 4 8.89391 40.7829 25.2096 -1.06312 24.7623 5.36493 +6789 6 42.3301 10.2778 9.76455 0.0249942 22.0437 -8.66619 +6790 4 42.035 10.1947 10.6715 6.68889 -4.55788 7.04955 +6791 4 42.6957 11.1854 9.68656 -1.85544 -15.7885 0.75259 +6792 6 13.241 7.61416 1.95847 -11.6175 -6.73398 30.6404 +6793 4 13.9892 7.82191 2.54806 -1.36929 5.6022 -7.80568 +6794 4 12.5695 7.22502 2.56499 11.7798 7.16895 -16.7116 +6795 6 18.7434 40.0583 14.2212 10.8937 -7.32712 21.4541 +6796 4 19.2417 39.7541 15.0131 -1.99408 15.6159 -18.1773 +6797 4 17.935 39.549 14.2832 -4.44855 -3.57314 -3.37042 +6798 6 20.0977 14.0454 38.5561 35.4799 -67.417 -7.49733 +6799 4 20.2641 13.632 37.67 -9.31749 10.6865 24.2255 +6800 4 19.7827 14.877 38.3297 -23.7972 64.5272 -8.60678 +6801 6 22.6565 28.8842 34.0588 -5.52315 8.37947 20.7951 +6802 4 23.0585 28.228 33.4828 2.77778 -4.34029 0.307399 +6803 4 22.9395 28.703 34.9822 0.354749 -6.57221 -14.6515 +6804 6 22.6874 4.70198 5.2328 -25.042 -9.90055 15.5414 +6805 4 22.1274 3.9708 5.56882 12.1557 -0.0327816 -16.8284 +6806 4 22.5434 5.31639 5.94822 12.9551 16.3877 4.62095 +6807 6 23.6492 33.9942 38.3998 23.375 33.8394 -43.1733 +6808 4 22.8011 33.6715 38.57 -44.227 -25.7371 21.164 +6809 4 23.4749 34.4069 37.5183 19.103 -7.547 16.6445 +6810 6 48.374 21.3549 17.2744 -0.727013 41.2048 -23.9838 +6811 4 48.2041 22.3166 17.0448 3.0192 -25.1475 26.0409 +6812 4 48.3509 20.9743 16.3868 -2.31832 -8.94154 10.8829 +6813 6 11.5758 10.9938 8.63273 -18.0621 42.8191 15.9647 +6814 4 11.6313 10.2483 9.25156 -2.19238 1.01339 1.87179 +6815 4 11.0547 11.7764 9.03291 21.9333 -36.8133 -6.7089 +6816 6 40.0924 28.1686 33.4857 17.1635 -5.37387 30.2378 +6817 4 41.046 28.3881 33.5354 -13.2006 -3.32107 -11.2861 +6818 4 39.7443 28.4933 32.6629 4.51627 6.28126 -11.3213 +6819 6 47.3837 25.6703 5.29617 28.7657 21.9065 -4.48206 +6820 4 46.461 25.5322 5.12569 -20.8862 2.51482 -4.893 +6821 4 47.6179 26.6114 5.08959 -12.3293 -15.1007 -0.275896 +6822 6 21.6517 35.2222 23.996 27.7917 10.3485 -3.89698 +6823 4 21.6311 34.5383 24.6593 -10.5502 -12.8786 6.64496 +6824 4 22.5954 35.4881 23.9966 -15.7417 2.23004 -2.6139 +6825 6 8.24409 41.4919 8.41354 9.22969 12.4334 -12.8549 +6826 4 8.15 40.8674 7.67873 -1.07657 -2.81584 5.48771 +6827 4 7.83543 41.113 9.18983 -1.52095 -3.2343 5.88405 +6828 6 16.4798 31.1082 22.2131 -4.24513 -17.8742 -2.35359 +6829 4 17.0752 30.8161 21.5077 -7.18137 4.28218 -7.0656 +6830 4 17.0564 31.1902 22.9696 5.97679 -0.907857 10.4567 +6831 6 54.7122 0.459271 28.3177 -16.7834 -37.5181 -6.57119 +6832 4 0.641958 0.15455 28.3975 4.09167 16.1916 -1.73275 +6833 4 54.5379 1.34634 28.6236 20.797 14.6923 4.72985 +6834 6 48.4477 15.3762 4.17752 -7.35125 -30.0531 -4.44848 +6835 4 49.1738 15.1128 4.81019 -14.8803 0.337287 -24.8229 +6836 4 48.0902 14.5922 3.6288 23.2827 31.0113 24.8784 +6837 6 34.3541 7.00171 40.4295 26.6588 -46.9533 -23.8625 +6838 4 33.6168 6.99428 39.8319 -14.4938 10.2897 -3.98371 +6839 4 34.9839 6.35967 39.9588 -19.3291 28.4488 24.7248 +6840 6 41.3507 3.37676 17.0028 -19.6969 -26.4955 -6.96819 +6841 4 41.02 2.66518 17.5936 5.53648 12.9859 -1.78552 +6842 4 41.944 3.90566 17.5305 10.5068 9.85924 8.73726 +6843 6 48.4427 20.685 14.5419 46.8112 -36.6841 26.4704 +6844 4 48.0177 21.3487 14.0717 -32.7597 47.8552 -32.6818 +6845 4 49.3877 20.9188 14.5227 -9.08294 -4.43462 -1.64124 +6846 6 52.4922 28.1277 37.1182 6.87418 8.84651 -10.3419 +6847 4 53.4134 28.4024 37.0408 3.12987 -6.6922 4.15316 +6848 4 52.2752 27.8963 36.2007 -7.47166 7.06161 9.73328 +6849 6 53.8774 18.5638 18.79 -18.2161 -77.5341 7.0005 +6850 4 54.7018 18.1425 18.5274 3.76082 -0.315502 -3.76089 +6851 4 54.0435 19.4528 18.7445 16.4561 77.5259 -2.54699 +6852 6 41.0011 39.1407 28.7879 -31.3786 -4.09579 71.7092 +6853 4 41.3911 39.2094 27.9661 28.9736 8.71878 -68.6315 +6854 4 40.0521 39.3021 28.7019 -2.27612 -3.41331 -6.23213 +6855 6 38.2743 8.75074 24.2285 24.5029 -7.68366 -19.8132 +6856 4 39.1919 8.60362 23.8621 -28.3827 4.68959 18.7737 +6857 4 38.3545 9.42009 24.9092 0.456349 2.35846 11.2764 +6858 6 2.99111 29.1615 9.6319 43.2691 -54.6401 14.341 +6859 4 2.5338 28.6319 8.99687 -12.0219 1.86489 -18.3516 +6860 4 2.58318 29.9865 9.638 -27.8835 49.5023 8.75508 +6861 6 27.5756 29.2755 18.3378 -4.01048 -11.7045 41.1881 +6862 4 26.7643 29.1652 17.8389 -11.7278 -2.11582 -9.62984 +6863 4 27.2839 29.0037 19.2864 20.9622 13.2114 -52.0932 +6864 6 11.8501 21.1733 10.1172 4.58733 -51.566 26.4002 +6865 4 12.2099 22.0246 9.9906 13.4732 33.828 -10.0235 +6866 4 12.4495 20.7458 10.776 -15.5727 16.0367 -15.8372 +6867 6 16.9004 32.2989 0.299881 0.133752 -22.2186 -6.7835 +6868 4 17.7029 32.7095 0.626455 9.4749 11.3588 3.4417 +6869 4 16.2118 32.9605 0.285394 -3.66285 20.1796 -4.1714 +6870 6 1.30064 17.4766 22.5523 32.9941 -5.4384 -19.965 +6871 4 1.2446 16.5356 22.2294 -6.1018 21.6977 3.5382 +6872 4 2.22906 17.8023 22.3815 -23.7878 -13.737 8.2324 +6873 6 41.5474 6.85538 29.3077 15.2611 30.5857 3.861 +6874 4 41.7413 5.96016 29.5642 -1.91107 -14.5726 0.121693 +6875 4 42.0251 7.37916 29.9826 -12.8279 -1.76094 -5.06557 +6876 6 10.5087 10.782 13.8577 27.0965 -13.6956 13.3978 +6877 4 10.7007 11.2274 13.0253 -2.16043 3.73872 -7.98734 +6878 4 11.2742 10.169 14.0479 -24.5023 11.0776 -3.5626 +6879 6 39.8289 15.4978 40.8346 25.2099 1.13818 0.661387 +6880 4 40.0487 16.0673 40.0758 -9.90377 -2.84048 2.34508 +6881 4 40.6829 15.4254 41.3222 -18.4618 6.82556 -4.74882 +6882 6 26.5164 19.6052 40.5088 -9.33805 1.61856 -11.7217 +6883 4 27.41 19.9717 40.4897 0.274496 -7.70925 5.49567 +6884 4 26.4209 18.9712 41.2422 6.64723 7.57269 5.06511 +6885 6 54.036 8.18782 13.7715 27.5212 34.9045 -2.54262 +6886 4 54.5316 7.46918 14.1378 9.61628 -19.3806 0.327355 +6887 4 53.1925 7.88218 13.5309 -39.9219 -15.1658 -7.5943 +6888 6 15.6949 25.3434 10.6718 -31.7842 -7.37099 0.0612328 +6889 4 15.1805 25.3333 9.84403 14.6699 1.30202 -4.92807 +6890 4 14.9666 25.3615 11.3188 15.8696 -4.15214 -3.47235 +6891 6 18.5987 3.44175 21.9294 71.7321 -9.69418 15.9409 +6892 4 19.6071 3.44542 22.1959 -64.1569 1.8736 -14.3483 +6893 4 18.6296 3.58776 20.9721 -7.77871 5.49431 4.81248 +6894 6 50.8883 20.6265 18.5187 28.1172 41.6529 17.9746 +6895 4 50.1573 21.1733 18.1958 -9.23125 -9.06144 -4.34911 +6896 4 51.4834 21.2842 19.0045 -23.468 -29.5191 -15.1667 +6897 6 53.3673 20.9038 31.2869 -12.1652 -1.18869 -3.23134 +6898 4 53.2409 20.9073 32.2442 5.88471 -1.70994 -0.407299 +6899 4 52.4717 20.8062 30.9053 11.2743 1.61965 3.90294 +6900 6 52.8102 27.6189 28.9831 -34.4743 -7.30027 30.0453 +6901 4 52.2848 27.4362 29.7987 1.4862 0.901255 -27.4551 +6902 4 53.4947 28.1361 29.3473 35.4934 25.3811 1.80223 +6903 6 33.3112 15.6955 11.3264 12.7704 9.00306 37.7013 +6904 4 33.4999 16.1238 12.2198 -3.00415 -23.4283 -28.8796 +6905 4 32.4346 16.0003 11.1059 -7.33456 8.94646 -4.12361 +6906 6 20.3875 26.8057 27.4813 21.213 -4.31231 15.2493 +6907 4 19.6396 27.3594 27.2578 -2.8557 9.66202 -0.370116 +6908 4 20.9667 27.2946 28.1279 -24.4059 -13.8952 -19.2793 +6909 6 8.54399 2.06163 14.1713 4.36483 17.1543 -0.299448 +6910 4 8.13837 1.20516 14.196 -9.47708 -17.773 2.17407 +6911 4 8.01805 2.60085 14.7902 6.78451 -6.83093 -3.12033 +6912 6 40.1002 7.56575 40.6778 12.4019 9.60944 38.6013 +6913 4 39.712 8.14959 41.3779 4.03526 -4.70584 -30.6789 +6914 4 40.8329 7.16354 41.1893 -8.78874 -6.51591 -16.4763 +6915 6 6.89044 6.83556 10.7869 16.1514 15.8461 -3.23426 +6916 4 7.31622 7.70217 10.5979 -16.164 -15.6489 3.8938 +6917 4 7.04178 6.69918 11.735 -3.2221 -0.411834 -4.21297 +6918 6 31.2643 6.58983 20.136 22.5576 -57.6677 6.94967 +6919 4 30.6637 5.92034 20.5005 -2.47046 2.78164 8.35653 +6920 4 30.7152 7.30056 19.9711 -35.0351 52.1138 -11.6241 +6921 6 54.5411 21.0454 27.2925 4.1013 -43.0328 84.8338 +6922 4 0.071192 20.2129 27.5399 -15.6737 30.1382 -21.2093 +6923 4 54.6532 21.3072 26.4181 12.1035 8.54749 -60.3726 +6924 6 4.75213 23.1508 16.2245 -49.4139 4.34438 -28.0546 +6925 4 4.2471 24.0009 16.1592 20.3634 -17.2761 5.59937 +6926 4 5.4972 23.3136 16.7675 27.2932 5.42097 22.4316 +6927 6 25.5515 11.0241 14.8358 9.2665 0.546345 5.2197 +6928 4 26.0976 10.3608 15.3182 -9.73323 12.0118 -14.516 +6929 4 25.8683 11.8947 15.1133 0.0398252 -5.90721 -2.6003 +6930 6 41.1974 41.7784 29.942 -27.7855 -7.97533 -10.6302 +6931 4 40.9203 40.8727 29.6366 8.3922 29.767 6.72032 +6932 4 40.4023 0.465719 29.8931 18.9924 -15.525 2.17149 +6933 6 52.2793 15.2936 41.6313 19.4314 -9.06844 -20.2837 +6934 4 51.991 15.9601 0.331443 -10.9307 10.9541 10.4228 +6935 4 51.6032 14.6231 41.5544 -13.8311 -6.7739 0.824233 +6936 6 37.7418 21.7882 37.8505 9.73059 24.2058 3.49681 +6937 4 37.8176 20.8655 37.6583 6.26781 -24.8638 0.142384 +6938 4 38.1128 21.8753 38.7352 0.661952 0.248137 2.40564 +6939 6 23.8436 9.73697 27.5598 -17.3101 -56.824 -21.1542 +6940 4 23.6823 8.97924 26.8635 13.0753 42.6322 38.797 +6941 4 23.3674 9.48178 28.3892 6.27388 8.11738 -19.7561 +6942 6 43.0121 28.0431 32.8137 29.5034 -18.022 1.83467 +6943 4 42.9555 27.148 33.1715 -16.7807 6.42622 4.12236 +6944 4 43.9561 28.0675 32.5908 -15.6612 14.0802 -2.62256 +6945 6 34.1451 21.2362 11.9042 -10.4207 -39.0944 -3.26361 +6946 4 33.7785 20.3444 12.1585 8.75301 27.3815 0.918114 +6947 4 33.7383 21.3833 11.0382 -2.92284 10.3561 2.31655 +6948 6 10.5016 31.8267 10.0873 5.91889 6.7472 5.74276 +6949 4 10.9186 32.6594 10.3946 -11.2895 -14.4825 -9.55855 +6950 4 9.99233 32.0033 9.274 9.03923 7.50024 8.93884 +6951 6 35.8744 37.1309 22.1208 9.07655 -0.20125 -37.6945 +6952 4 36.7757 37.5102 21.9868 -16.2539 -8.14962 7.83623 +6953 4 35.5893 37.243 23.0078 -0.963312 7.56509 34.0991 +6954 6 27.293 4.59192 27.4599 -62.9251 -2.97268 8.43797 +6955 4 27.8573 4.63875 28.2367 1.75868 -0.322614 6.7695 +6956 4 26.3027 4.46726 27.7774 60.9698 2.85981 -12.9146 +6957 6 39.0165 22.2861 10.6525 -25.2911 9.99335 20.5692 +6958 4 39.5938 21.9801 9.97437 16.8498 -5.94336 -19.6369 +6959 4 38.1468 22.3658 10.2352 2.38909 -7.32087 0.337973 +6960 6 30.765 39.1813 10.9358 -26.8864 17.0789 0.421318 +6961 4 31.7273 39.1993 11.0368 0.254075 -10.0442 -6.8497 +6962 4 30.3957 38.288 10.8473 24.5485 -0.522695 0.476538 +6963 6 44.5972 26.9475 2.20695 17.6159 -27.9211 -0.145864 +6964 4 44.8477 26.0903 2.61727 -13.9349 20.2639 -7.87324 +6965 4 45.3006 27.0404 1.55025 0.322606 15.9 1.66232 +6966 6 23.7817 14.549 26.4845 -13.1218 37.1912 -28.6876 +6967 4 23.5085 15.1786 25.7375 18.3344 -26.327 26.4977 +6968 4 23.2314 13.7794 26.3439 -3.10125 -8.02717 6.138 +6969 6 38.3349 13.3785 39.6531 51.0719 11.8768 18.627 +6970 4 39.1134 13.8424 40.1004 -28.3003 -20.0613 -21.9332 +6971 4 37.637 14.0102 39.7945 -20.9869 -1.09015 1.55638 +6972 6 17.9076 17.2343 29.3998 2.5182 -11.8623 9.07057 +6973 4 17.7005 16.8028 28.5679 -0.208052 -3.06359 -6.42367 +6974 4 17.2973 17.9612 29.4206 -13.3644 14.2602 6.84169 +6975 6 17.427 29.8312 9.9167 5.70667 9.14636 11.5297 +6976 4 16.5259 29.8398 9.63655 -18.5043 -5.93208 -2.5299 +6977 4 17.9097 29.6705 9.11934 16.3543 -3.78316 -10.6623 +6978 6 35.6302 6.05705 19.6249 -12.632 -1.17761 -30.1407 +6979 4 35.1756 5.57436 18.904 4.12491 -0.359791 14.6292 +6980 4 35.7342 6.9119 19.1826 9.40393 1.91765 12.7562 +6981 6 18.674 22.2857 17.523 8.42296 3.39096 21.1197 +6982 4 17.7402 22.4481 17.6821 -9.17854 0.615652 -6.61815 +6983 4 18.8674 22.3747 16.5992 -7.41694 3.44878 -20.9034 +6984 6 20.0258 3.81405 32.2871 -5.45876 10.2161 0.982716 +6985 4 19.684 4.03807 31.424 -2.67861 3.00481 -7.64614 +6986 4 20.9375 3.54321 32.099 -1.59169 -5.33194 9.42598 +6987 6 5.47094 6.98417 8.10987 -1.95658 -27.204 5.03178 +6988 4 5.85072 7.84658 8.088 3.96324 28.039 -6.11929 +6989 4 5.94584 6.55919 8.82772 -3.50663 -6.33739 10.9422 +6990 6 44.182 20.5312 25.5979 43.1361 -13.705 -19.148 +6991 4 44.6875 21.1042 26.1493 -15.9255 27.6084 29.7698 +6992 4 44.9726 20.2272 25.1253 -26.0739 -14.4287 -20.9555 +6993 6 43.9621 36.9892 17.8709 27.7049 17.1418 -9.42399 +6994 4 44.6647 37.4643 17.3692 -13.724 -4.61297 12.4448 +6995 4 43.6121 36.3808 17.225 -14.1002 -14.0328 0.985329 +6996 6 34.6183 10.1148 16.2555 -4.96303 14.2933 -37.1542 +6997 4 34.4099 10.1014 15.264 7.63186 -7.52385 38.4141 +6998 4 34.6455 11.0716 16.4378 1.03434 -4.81203 3.48645 +6999 6 23.6535 3.43617 1.32551 9.32991 -27.0385 -60.023 +7000 4 23.5361 2.47498 1.09872 1.70789 26.2755 24.74 +7001 4 23.8607 3.79652 0.414552 -11.3127 6.44054 37.9529 +7002 6 33.4225 38.9606 5.09116 -45.0556 15.9463 14.7537 +7003 4 32.9187 38.171 4.91655 10.2233 -24.4058 -4.43744 +7004 4 32.6531 39.5198 5.39063 34.9247 3.3662 -8.43025 +7005 6 22.5542 32.508 35.8091 -1.62577 21.6885 -22.4452 +7006 4 23.4313 32.1432 35.8321 13.5304 -8.64793 9.08541 +7007 4 22.6972 33.4304 35.4917 -7.91418 -12.6316 15.6694 +7008 6 32.4209 37.2696 13.8263 22.6153 37.4816 -15.7005 +7009 4 31.6314 36.8608 13.5507 -35.0264 -17.3769 -13.0658 +7010 4 32.7321 36.7183 14.5153 12.3601 -27.6025 17.2047 +7011 6 52.6048 12.7515 39.5965 -13.8302 -6.28036 -1.32475 +7012 4 53.26 13.3571 39.2655 9.70847 9.80763 -6.22213 +7013 4 53.0114 12.2827 40.3245 7.10516 -3.61819 3.538 +7014 6 28.8284 14.5654 1.23244 38.3097 18.383 -14.9432 +7015 4 28.2834 13.8143 1.34735 -23.3809 -22.0338 3.15251 +7016 4 28.3672 15.33 1.56727 -9.74512 0.414323 3.22557 +7017 6 1.45359 32.4205 23.3989 -1.05001 -40.1011 -18.1189 +7018 4 1.47013 31.5606 22.9188 -1.41837 10.7967 19.8874 +7019 4 1.97354 32.9442 22.8182 11.5552 29.203 -12.5869 +7020 6 54.3296 23.3325 28.9716 1.50467 4.34178 0.834044 +7021 4 54.2574 22.8567 29.7964 -0.193368 0.82753 11.1745 +7022 4 54.4723 22.6371 28.331 0.325397 -5.40149 -8.07104 +7023 6 14.3127 12.1509 35.6633 -33.5663 -10.8168 -13.6472 +7024 4 14.2878 12.7047 36.4184 6.74358 21.3133 20.6565 +7025 4 15.1756 11.8015 35.6107 35.8459 -8.25269 -4.05635 +7026 6 18.9986 6.53226 41.2771 -21.1361 -24.8418 -24.3627 +7027 4 18.366 5.78703 41.1105 9.63211 18.6573 18.8829 +7028 4 19.3119 6.48514 0.272589 3.11598 2.01554 11.5533 +7029 6 5.32991 17.8836 20.3428 -30.4167 16.0599 6.69424 +7030 4 4.7967 18.411 19.709 2.93149 -9.05217 4.33299 +7031 4 4.77097 17.8526 21.1546 15.0176 4.61027 -13.5236 +7032 6 24.7236 34.9657 30.1688 -3.59195 -26.0802 -14.261 +7033 4 24.7803 35.9013 30.0428 5.00342 21.1487 3.94382 +7034 4 24.6904 34.5809 29.2706 1.13339 13.2018 12.9935 +7035 6 31.868 4.6188 18.1813 26.0749 -11.7783 -2.21043 +7036 4 31.7807 5.26575 18.8694 -2.85928 14.415 8.06415 +7037 4 31.0011 4.54965 17.8036 -17.7428 -0.954819 -5.29079 +7038 6 8.70915 17.4782 5.92977 -5.10088 36.478 0.166614 +7039 4 7.99285 18.1665 5.8727 10.0003 -20.7449 -0.10219 +7040 4 9.53277 18.014 5.87919 -8.17468 -12.6369 7.06335 +7041 6 29.8448 10.9674 14.467 -9.24737 10.8237 6.24964 +7042 4 29.3518 11.4625 13.8111 -3.5417 -3.22768 -11.9456 +7043 4 29.8741 11.602 15.1948 7.6561 -6.41884 12.5924 +7044 6 48.7193 10.2987 32.5837 48.7914 -16.5053 -5.27468 +7045 4 48.664 9.84191 33.449 -1.5926 15.0761 -9.20872 +7046 4 49.6917 10.1556 32.2801 -49.2626 10.4163 8.33251 +7047 6 8.33128 15.6672 37.865 4.36755 4.12409 -33.9682 +7048 4 8.08142 16.0688 38.661 -6.22033 14.9054 48.1983 +7049 4 7.78443 16.1766 37.2488 7.82296 -4.92397 -7.06368 +7050 6 50.3849 3.07587 17.3306 53.0616 0.797084 -5.54454 +7051 4 49.9901 2.96071 16.4818 -23.7547 4.5323 -14.3202 +7052 4 49.831 3.21284 18.0832 -29.2444 4.71684 15.357 +7053 6 14.687 38.3962 10.9034 11.8452 2.26847 -28.7684 +7054 4 14.4993 38.5723 11.8231 -13.1425 0.700252 11.382 +7055 4 14.2628 37.5785 10.602 -2.45756 1.24341 13.1034 +7056 6 34.1174 6.37976 10.8168 12.9161 5.50138 13.5595 +7057 4 34.1292 7.23477 10.3416 2.23773 -14.4836 1.59416 +7058 4 34.9287 6.34152 11.3848 -14.7297 9.70771 -12.8953 +7059 6 7.1619 37.5492 17.6341 50.2032 -5.81562 0.15107 +7060 4 8.17599 37.5098 17.465 -47.7372 -0.307972 7.49553 +7061 4 7.05745 37.0565 18.4805 -8.53445 9.44148 -12.9936 +7062 6 51.515 11.3168 16.7982 -26.0757 5.86397 -27.0874 +7063 4 52.235 10.8459 17.1551 30.0977 -19.3818 20.7126 +7064 4 51.5008 11.0547 15.8562 -2.22905 10.0255 8.80825 +7065 6 15.6633 8.64974 3.19872 2.04011 -21.0584 -36.8111 +7066 4 15.359 9.2987 3.81038 -7.3063 19.0886 25.5551 +7067 4 16.1924 8.00887 3.67257 5.32849 -2.14206 7.59436 +7068 6 5.43671 21.4488 11.9213 -35.1135 30.2715 2.68526 +7069 4 5.1197 22.3031 11.5306 26.1226 -15.3225 -1.30607 +7070 4 4.71321 21.2794 12.5494 12.8867 -7.97314 3.40019 +7071 6 50.1888 24.041 37.9733 -16.5158 11.6838 -8.72192 +7072 4 49.5513 24.2503 37.2525 13.6843 -9.6942 16.9361 +7073 4 50.7608 23.3204 37.7156 0.52347 -2.66969 -5.08066 +7074 6 39.7366 11.2383 31.6978 23.7892 31.0409 -10.9794 +7075 4 40.3477 11.919 31.322 -8.85632 -23.7146 9.45819 +7076 4 38.8907 11.643 31.516 -11.7678 -2.00245 1.00495 +7077 6 26.6862 10.831 20.5846 -4.64528 13.8134 22.6501 +7078 4 26.37 11.3609 21.3584 5.46785 -6.26709 -23.7021 +7079 4 26.5097 9.94471 20.9062 3.28762 -9.42115 -6.7075 +7080 6 12.5617 17.5693 18.1619 57.3415 -16.6047 -35.4946 +7081 4 12.3732 16.6356 17.927 -10.1847 12.7431 11.2408 +7082 4 11.9536 17.9401 18.7496 -47.3477 6.23269 31.2745 +7083 6 47.7779 31.603 17.3345 -16.0229 -2.6295 -18.0517 +7084 4 48.4774 31.3981 17.9449 0.342859 -12.7175 10.4199 +7085 4 47.3751 30.7658 17.0144 6.51745 15.1025 2.87388 +7086 6 1.06661 3.38166 18.5387 0.482315 1.39351 -20.5486 +7087 4 1.47214 3.81044 19.3024 -7.19452 2.23946 8.83247 +7088 4 0.121217 3.21323 18.6865 2.92702 6.89788 10.7589 +7089 6 26.5916 20.3882 15.3141 4.05487 -19.1164 -7.10575 +7090 4 27.0276 19.5492 15.0037 -7.93965 16.9744 10.3813 +7091 4 25.6772 20.1067 15.4922 9.40368 -0.641397 -3.80974 +7092 6 42.0092 3.03717 36.7607 9.58516 7.42569 -27.539 +7093 4 41.472 2.27114 36.5289 -4.68032 -10.5632 12.6255 +7094 4 41.9749 3.27199 37.6769 -10.2045 -8.66607 25.0137 +7095 6 39.3197 22.4482 33.2161 17.1359 -6.1719 -1.11969 +7096 4 39.6777 22.5385 34.1471 -14.6651 4.73191 -34.7467 +7097 4 39.2891 23.3308 32.7977 1.66572 -7.01471 12.3298 +7098 6 18.4983 34.959 11.9233 -52.4092 11.8234 -6.15541 +7099 4 19.3311 34.9297 12.2931 62.358 -5.27325 28.8625 +7100 4 17.9525 35.2018 12.6795 -15.7268 -2.39727 1.11957 +7101 6 22.849 14.1156 0.206953 9.43339 -22.8796 20.8561 +7102 4 23.1273 14.7687 41.4941 9.338 18.1693 -9.76493 +7103 4 23.4344 14.2183 0.991573 -8.36464 7.13735 -11.7533 +7104 6 31.0127 16.6435 33.7717 -75.3989 -12.3916 10.6429 +7105 4 30.4261 16.8588 33.0132 20.7291 0.745933 12.1228 +7106 4 31.8948 16.7604 33.5238 39.9201 13.7608 -15.1754 +7107 6 28.4056 35.5121 5.54765 -4.91817 12.0412 -0.933493 +7108 4 29.0647 34.8486 5.74161 15.0982 -5.96625 -1.02933 +7109 4 28.8561 36.3656 5.44297 -1.6946 -6.58589 1.12865 +7110 6 2.06022 31.4415 10.6404 20.6415 1.38777 10.2498 +7111 4 2.4899 32.1989 10.2195 -2.44284 -2.19106 -3.22737 +7112 4 1.13111 31.6267 10.6164 -17.6565 -0.143118 -7.1498 +7113 6 5.95467 9.75858 21.3545 2.17354 8.87983 -50.8842 +7114 4 6.2643 10.5435 20.7894 -11.3634 -34.5597 22.4005 +7115 4 5.48441 9.14719 20.7121 9.8282 23.6666 23.1144 +7116 6 24.7866 26.6177 2.6661 -24.4024 -28.5469 2.9707 +7117 4 23.9476 26.6963 2.18158 9.10826 11.4817 -7.6186 +7118 4 24.6214 25.7954 3.1805 15.5163 19.2379 2.11057 +7119 6 45.7515 4.24664 18.6084 -0.948574 6.19926 2.59566 +7120 4 46.4738 4.91595 18.5123 -9.05862 -19.7882 -0.326833 +7121 4 46.0843 3.34349 18.421 4.31178 15.089 3.21664 +7122 6 4.45878 0.783326 15.9106 20.8465 2.39674 -2.22601 +7123 4 4.33336 41.7534 15.8294 -11.1347 -14.3847 -2.31303 +7124 4 5.37758 0.813141 16.2285 -10.0444 13.1447 -0.149196 +7125 6 2.44065 19.4988 25.3899 -18.2163 -19.9205 28.2208 +7126 4 1.89428 18.9873 26.0273 4.60516 17.0002 -8.33323 +7127 4 2.55045 18.8717 24.6878 9.48029 -1.77855 -17.0048 +7128 6 40.6027 8.48954 5.10826 -27.6355 -21.4881 -13.6167 +7129 4 40.6592 9.31425 5.57088 10.9479 16.5697 14.8472 +7130 4 41.3781 7.96424 5.30637 14.4251 2.68711 -2.52113 +7131 6 49.3092 22.3481 41.5186 -9.93734 74.0457 16.0776 +7132 4 48.4971 22.7919 41.1786 21.3857 -10.289 -0.267672 +7133 4 49.2285 21.4633 41.2985 -4.59952 -62.95 -16.8011 +7134 6 0.364483 40.9333 20.5966 -24.8933 -11.8265 -30.66 +7135 4 0.190818 39.9667 20.5681 4.35782 8.08342 1.06674 +7136 4 54.6936 41.3396 19.9676 13.1862 -7.22974 19.6204 +7137 6 34.8864 15.3279 38.0452 -17.1782 37.3505 -55.2903 +7138 4 34.2682 16.0872 37.9321 5.94042 -16.3876 6.60377 +7139 4 35.3697 15.4116 37.1797 -1.56134 -6.74346 24.1748 +7140 6 7.76223 25.9987 29.8652 25.7268 -8.51605 -4.95409 +7141 4 8.61839 26.4638 29.9588 -13.1921 -1.71741 1.7916 +7142 4 8.05672 25.0651 29.9772 -19.4202 16.3818 3.54783 +7143 6 40.7182 22.7954 20.4441 37.8127 13.8011 -33.8007 +7144 4 41.3586 23.4588 20.0133 -28.9149 -26.2189 23.8294 +7145 4 40.2017 23.2969 21.0583 -10.7099 15.3396 13.8501 +7146 6 37.6932 25.6399 36.0638 4.62997 10.0285 35.1853 +7147 4 38.3287 24.9236 36.1183 -2.20273 -4.01008 -9.65359 +7148 4 37.2914 25.6394 35.2107 -7.09628 -5.12362 -31.4654 +7149 6 5.46101 24.0014 10.2586 17.9799 16.5872 6.22131 +7150 4 6.04134 23.844 9.49543 -11.5162 -2.35388 5.85767 +7151 4 5.90746 24.7967 10.672 -23.415 -30.7572 -16.8601 +7152 6 48.4104 21.0451 38.1819 10.5351 27.9197 -28.7006 +7153 4 48.793 20.7803 39.017 13.2175 -6.38321 0.209366 +7154 4 49.1228 21.3802 37.5459 -28.8109 -18.4864 30.6779 +7155 6 15.2906 25.011 3.54101 2.70625 6.69817 -9.95824 +7156 4 15.4569 24.0555 3.50682 -9.52162 -0.514188 6.9158 +7157 4 14.6826 25.2483 4.2581 -1.83637 -10.9582 1.3864 +7158 6 46.3949 40.2718 20.0841 3.05266 -42.5213 0.389481 +7159 4 46.7282 39.319 20.1688 -17.5494 37.8624 -2.40649 +7160 4 47.138 40.8016 20.3323 14.2597 18.5668 -0.122304 +7161 6 34.6662 36.4732 0.324161 -52.0076 35.1593 -1.38074 +7162 4 34.82 35.9689 1.09464 17.4812 -18.6855 30.1307 +7163 4 33.7817 36.8781 0.601954 33.7085 -7.09846 -24.72 +7164 6 52.5968 8.00424 30.4116 -30.791 -5.83914 -1.44892 +7165 4 52.0396 8.66036 30.8559 12.8564 7.40177 -0.477247 +7166 4 51.9287 7.58179 29.8369 22.2614 -6.63703 0.63559 +7167 6 32.0772 3.86049 29.4688 -16.0025 -7.01815 -35.05 +7168 4 31.5382 3.03776 29.5615 20.8838 14.671 -1.22835 +7169 4 32.0904 4.03293 28.4798 -1.86833 -11.5506 40.3284 +7170 6 20.363 17.8245 28.646 3.47804 13.7512 -7.92665 +7171 4 19.5516 17.4966 29.0653 6.53113 9.74715 -6.36853 +7172 4 20.0825 18.3002 27.8308 0.555567 -8.90179 15.8758 +7173 6 30.4041 41.1634 41.0132 -16.7253 12.0993 -9.83452 +7174 4 30.5197 40.835 40.1072 4.71307 -5.7925 7.34595 +7175 4 31.1703 40.9637 41.5368 18.7313 -7.07732 1.06037 +7176 6 35.4542 32.8539 27.9215 21.6406 26.5455 -21.3275 +7177 4 35.1435 33.2362 28.7432 -6.21594 5.85967 7.97646 +7178 4 35.8745 33.6007 27.3754 -13.2283 -32.0923 16.9769 +7179 6 14.39 6.67952 12.731 -12.5058 36.491 0.424373 +7180 4 15.2321 6.28981 12.9462 8.74388 -6.1299 -2.75421 +7181 4 14.5067 7.66796 12.7988 -3.69921 -34.1177 -6.56265 +7182 6 41.8739 41.5433 20.319 24.4238 12.2951 6.29746 +7183 4 42.7192 41.2715 19.9184 -11.0628 6.38436 -6.30872 +7184 4 41.3184 40.7767 20.2955 -10.4459 -12.1473 -5.48062 +7185 6 46.3985 22.5739 8.8638 6.84921 19.3184 1.79378 +7186 4 45.8729 21.8991 8.42669 -3.07803 -12.5032 3.12866 +7187 4 47.1271 22.1566 9.33065 -8.50589 -8.34396 1.5145 +7188 6 17.4023 20.6526 13.9004 10.6995 28.5611 -11.4854 +7189 4 17.6978 21.6036 13.9579 -8.84666 -31.3302 7.07381 +7190 4 17.3123 20.5004 12.9448 0.490636 -3.23538 4.08121 +7191 6 8.20126 9.48382 13.3485 -42.4293 41.8522 17.2798 +7192 4 7.44487 10.0964 13.6076 19.5538 -29.8853 -13.4391 +7193 4 8.9576 10.0119 13.6277 13.7224 -9.45646 -1.54211 +7194 6 7.58554 14.8008 29.5824 -2.61798 9.90858 -2.64866 +7195 4 7.05733 14.3538 30.2458 -0.514214 1.68252 7.63674 +7196 4 7.01989 15.5029 29.2149 4.91731 -6.06465 -0.976267 +7197 6 29.5668 39.2268 22.6285 -3.66094 -2.39634 13.3419 +7198 4 29.8353 38.7557 23.4169 -4.20308 -7.76017 12.2752 +7199 4 30.3745 39.2765 22.1369 12.5997 4.36069 -18.8462 +7200 6 19.725 28.7952 8.44488 15.8543 2.58223 -4.45186 +7201 4 19.5131 27.8757 8.63421 -2.81313 1.38303 -4.16069 +7202 4 20.6983 28.808 8.54393 -13.7447 6.84799 3.59225 +7203 6 20.0995 21.6275 25.9249 -17.5249 50.4223 5.09745 +7204 4 20.7082 22.0204 26.5908 -8.84326 -18.264 -10.6066 +7205 4 19.3931 22.3347 25.9239 13.215 -30.9895 -3.48111 +7206 6 12.7711 16.1006 22.7986 17.0661 -2.75106 -3.7002 +7207 4 12.1316 16.7784 22.5952 -11.3059 6.43976 -4.8982 +7208 4 12.4647 15.3033 22.3372 -2.13756 9.04884 6.71194 +7209 6 7.09175 27.2069 17.991 -23.617 26.2366 -1.29155 +7210 4 7.8076 26.6007 17.9383 20.2011 -26.8554 -5.74897 +7211 4 7.19403 27.792 17.2318 3.33647 -0.0238245 -0.788587 +7212 6 32.3975 8.68618 34.8629 3.54321 22.8272 16.3539 +7213 4 32.7738 9.06402 35.707 -18.9002 -9.48773 -27.5474 +7214 4 31.4989 9.0701 34.6771 23.7457 -9.58556 9.46102 +7215 6 50.3515 28.2186 17.5351 -6.87553 0.519429 12.9107 +7216 4 50.2481 27.3572 17.999 6.5408 9.8464 -12.2276 +7217 4 51.0722 28.1417 16.8919 -2.26653 -7.3618 -1.59066 +7218 6 15.6741 32.1546 25.7968 -26.4348 -11.0143 -14.9159 +7219 4 16.4004 32.6083 26.1805 24.7846 13.6092 10.6573 +7220 4 15.1411 32.8481 25.3674 4.92309 -4.07512 11.5217 +7221 6 41.2877 22.001 29.6411 43.1174 -21.5596 15.2505 +7222 4 40.6305 22.5901 29.3541 -33.8214 23.827 -16.0773 +7223 4 40.8662 21.2212 29.998 -7.36398 -2.60921 4.02408 +7224 6 24.5416 12.7608 8.88206 5.17198 -11.9982 -20.3907 +7225 4 24.1774 13.5122 9.35398 1.69504 4.6425 -2.53241 +7226 4 24.2888 12.8675 7.94212 1.28664 -3.68024 15.0016 +7227 6 47.3025 20.1085 10.3977 1.21439 24.4816 37.2747 +7228 4 48.204 20.4596 10.4656 -0.7364 -8.12719 -10.3932 +7229 4 47.15 19.5905 9.61989 6.68365 -16.152 -23.0167 +7230 6 17.6916 14.2112 29.9613 0.736848 4.98565 -22.9932 +7231 4 16.8377 14.622 30.0672 -16.7241 9.37988 10.4211 +7232 4 18.1183 14.7557 29.2835 1.70081 -6.05446 6.16757 +7233 6 21.3481 34.5805 28.5342 -9.54463 9.82799 -20.865 +7234 4 21.5933 35.4178 28.0943 -1.05427 -4.62886 14.5387 +7235 4 21.7361 34.566 29.3968 13.4346 0.0141216 16.9261 +7236 6 35.1024 4.03924 4.01172 -45.5158 42.5484 12.3245 +7237 4 34.1858 3.89939 4.38295 32.1954 -12.7538 -7.33111 +7238 4 35.1016 5.02916 3.89259 9.91862 -26.8751 2.91657 +7239 6 29.9059 8.58368 22.6013 -13.5917 -22.6535 -48.6732 +7240 4 29.4773 8.30259 21.7189 15.3855 19.7125 42.6195 +7241 4 30.4378 7.8025 22.8052 -0.87874 9.41284 8.39762 +7242 6 9.78314 32.9658 15.9197 34.9354 -36.2496 39.6827 +7243 4 9.8463 32.0623 16.3137 -14.5131 14.3099 -26.4053 +7244 4 10.4229 33.3707 16.5321 -2.5459 17.7355 -14.0184 +7245 6 24.9212 14.2335 32.582 19.5351 -17.8621 25.1352 +7246 4 25.485 14.4356 33.3711 -14.9506 -0.509299 -20.0473 +7247 4 24.5508 15.0526 32.2925 -5.32053 16.7872 -6.18619 +7248 6 49.6539 21.965 26.2345 44.0267 25.2751 -8.97422 +7249 4 50.4399 21.435 26.5572 -22.3889 20.3635 -4.11669 +7250 4 50.0214 22.8598 25.9362 -18.5294 -37.2714 15.3372 +7251 6 39.2165 29.6282 28.7804 -1.72389 1.82743 -9.11301 +7252 4 39.3036 29.0201 29.5259 1.24025 -1.09654 1.55877 +7253 4 39.538 29.1266 28.0158 0.286751 -1.49672 5.82908 +7254 6 50.6899 34.7862 39.7499 25.3157 10.1005 12.0928 +7255 4 51.6472 34.6743 39.5192 -19.7186 -4.86584 -0.193213 +7256 4 50.1651 34.2508 39.1591 2.72681 -14.2758 -14.8682 +7257 6 29.2004 20.8742 19.5261 27.9811 -3.68804 20.7377 +7258 4 30.1466 21.1247 19.5553 -9.39276 -2.96688 2.79863 +7259 4 28.9246 21.1497 18.6738 -22.5466 15.5983 -24.0329 +7260 6 45.8438 1.42491 21.3861 -37.1737 6.40486 -10.0566 +7261 4 44.9885 1.11968 21.7285 6.97513 -0.0444158 -7.72874 +7262 4 46.4438 0.92117 21.8904 34.782 -15.8409 16.3481 +7263 6 26.1011 5.84859 12.9885 -16.9285 4.46913 -7.38549 +7264 4 26.5547 5.08441 12.6375 7.71787 -14.9735 6.0022 +7265 4 25.1614 5.66972 12.8036 4.71997 0.43883 -1.19571 +7266 6 9.00669 19.0403 23.7238 12.8928 30.373 -14.6892 +7267 4 8.06593 18.9071 23.7945 -12.9763 -5.98489 5.20443 +7268 4 9.0473 19.9093 23.2431 5.0983 -22.172 6.64837 +7269 6 47.6961 14.1782 40.0269 19.0377 9.97795 -11.4729 +7270 4 48.5222 14.3512 39.5239 -16.7083 -4.37767 10.6105 +7271 4 47.3795 15.0553 40.2888 -5.04524 -6.44815 -3.81417 +7272 6 47.9985 19.7874 0.500962 -66.9165 -27.0064 -39.4066 +7273 4 48.5513 19.9496 1.22397 26.1904 -2.55385 45.3318 +7274 4 47.2789 19.103 0.704655 34.6798 29.0788 0.973802 +7275 6 27.1606 39.6013 31.4318 -10.4761 -55.491 -38.6851 +7276 4 26.8926 40.2811 32.0159 -13.7359 20.3686 20.1783 +7277 4 26.3709 38.9998 31.2101 25.3937 25.349 18.055 +7278 6 20.7209 15.2822 27.3078 -0.805435 -7.71632 -8.78017 +7279 4 19.7876 15.3781 27.0487 8.25469 13.9731 2.34115 +7280 4 21.2532 16.0335 26.9925 -16.2498 2.55153 -4.46604 +7281 6 53.2722 3.12643 19.6849 41.3384 49.6686 7.26214 +7282 4 52.533 3.74254 19.7043 -8.02663 -2.92583 -3.0848 +7283 4 53.0086 2.23956 19.6703 -22.4403 -46.3419 -2.11618 +7284 6 40.7531 33.3786 24.0219 13.5521 -1.60379 23.9632 +7285 4 41.5067 33.1664 24.6167 -8.75803 3.71621 -14.936 +7286 4 40.1104 32.6626 24.1628 3.50492 2.6284 -2.95087 +7287 6 50.2066 37.8896 21.3771 44.4561 61.7722 -19.2089 +7288 4 50.9779 37.3435 21.496 14.3962 -14.5259 7.12428 +7289 4 49.4598 37.4098 21.5582 -59.0635 -51.549 13.7135 +7290 6 41.3233 2.3412 21.9924 -16.3503 12.7858 19.6024 +7291 4 41.3426 2.52207 21.0679 5.97541 2.4567 -21.4637 +7292 4 40.4663 2.75609 22.2585 17.532 -18.0725 0.252127 +7293 6 3.68867 21.2779 14.3383 -14.5707 42.5 -35.9941 +7294 4 4.12477 21.855 14.9587 9.56216 12.6885 8.47194 +7295 4 3.77328 20.4352 14.6935 9.76412 -50.205 23.6517 +7296 6 34.2782 11.1533 36.6146 -6.03132 -23.9347 13.7336 +7297 4 33.9924 10.5436 37.3334 13.9996 -4.78487 -21.5854 +7298 4 34.1172 11.978 37.0322 -7.62349 27.2634 9.28858 +7299 6 24.0533 21.9225 23.4615 4.73517 -5.47775 13.1649 +7300 4 23.9978 21.53 22.5886 6.00444 -6.53009 -8.74438 +7301 4 24.605 21.2935 23.9896 -10.4931 14.2472 -9.63662 +7302 6 18.8931 0.346665 4.41951 -1.70081 19.9518 7.76538 +7303 4 18.8368 41.3461 4.13842 4.04101 -8.25805 2.22226 +7304 4 19.3845 0.416823 5.25819 -4.2619 -8.11151 -12.0763 +7305 6 1.61167 7.82777 17.7295 14.4633 -7.55708 2.21629 +7306 4 1.68315 6.88308 17.5181 0.421421 7.02752 -3.81945 +7307 4 0.776664 7.94842 18.1735 -9.56642 1.01884 2.20602 +7308 6 9.88587 31.542 26.4865 27.4574 -58.0414 -32.6279 +7309 4 9.74723 30.8294 25.7579 9.18818 32.443 34.13 +7310 4 9.16596 32.1271 26.4328 -35.6644 31.0992 -1.66616 +7311 6 46.989 33.006 20.3636 -11.9681 -37.8677 44.1235 +7312 4 47.0707 32.5253 21.2626 7.56487 31.1056 -35.1941 +7313 4 46.435 32.3629 19.8924 4.61548 9.19147 -10.8851 +7314 6 49.5457 29.2916 21.3977 -38.7846 4.15079 -24.0209 +7315 4 50.3477 28.8236 21.2219 24.323 -7.55681 13.7085 +7316 4 49.5468 29.8542 22.1736 14.9668 -0.936193 10.2574 +7317 6 13.5153 31.8979 19.1528 13.8675 8.3184 29.6787 +7318 4 12.8458 31.9825 19.8587 16.0999 2.21739 -7.32054 +7319 4 14.3406 32.2634 19.5906 -25.0701 -6.26478 -24.6616 +7320 6 46.633 34.1066 16.9257 -0.036059 -36.1463 20.7227 +7321 4 46.8492 33.9929 15.9997 3.99258 8.43366 -10.882 +7322 4 46.9059 33.2223 17.3084 -4.9703 29.3867 -9.59361 +7323 6 19.7609 39.5392 2.42166 -7.20248 -0.896063 -14.0911 +7324 4 20.5606 40.0527 2.5788 -3.5749 4.99115 -1.28658 +7325 4 19.2738 40.0463 1.72337 11.6568 -15.7424 21.4794 +7326 6 16.5329 9.39795 28.3065 -12.6095 -8.72502 6.68605 +7327 4 16.4075 10.3536 28.3648 10.1088 3.80195 -3.74389 +7328 4 17.4502 9.20269 28.1082 11.2813 2.72217 -1.81406 +7329 6 3.0433 33.3643 8.96425 -4.92886 23.6682 -21.9772 +7330 4 2.41869 34.0757 8.74286 -2.57616 0.180013 17.6579 +7331 4 3.16376 33.0029 8.08154 7.55925 -16.3918 2.91827 +7332 6 49.6751 28.308 0.201579 -29.5359 7.30765 2.58258 +7333 4 50.5733 28.3754 41.8671 34.4717 0.327786 -9.88202 +7334 4 49.5726 27.4715 0.657175 -2.26504 -2.01296 8.34302 +7335 6 1.41619 6.84354 30.4994 -10.3235 0.0954103 3.42179 +7336 4 1.63397 7.74222 30.8225 4.19995 -13.4757 3.05915 +7337 4 0.761793 6.45905 31.124 14.5617 20.0187 -8.0296 +7338 6 19.7679 9.42131 33.717 -3.22882 -6.25654 -44.8315 +7339 4 19.9145 8.46604 33.7746 1.8774 1.59257 2.48781 +7340 4 19.5751 9.55831 32.7323 1.24521 6.76178 40.819 +7341 6 26.1724 11.919 3.61074 17.7641 10.7445 -19.8393 +7342 4 25.5356 12.1934 4.24073 -14.9718 14.8208 22.8097 +7343 4 26.0423 10.983 3.54915 1.55706 -20.7566 2.99847 +7344 6 33.2542 2.1444 18.2116 -1.15587 48.9982 3.93816 +7345 4 32.886 2.96086 18.6548 6.67205 -21.4839 -22.8104 +7346 4 32.6761 1.46025 18.493 -13.9253 -19.4899 6.26155 +7347 6 1.55797 29.1194 15.6221 -22.3111 36.2637 61.7506 +7348 4 0.853719 28.5449 15.936 -7.71843 6.28063 0.384394 +7349 4 1.90648 28.6788 14.9107 30.7784 -39.3832 -62.5327 +7350 6 41.7311 4.10421 39.5944 -40.7328 36.7616 -42.7174 +7351 4 41.3817 4.81242 38.923 27.6667 -38.3892 36.6931 +7352 4 40.9025 3.64602 39.8145 11.2401 -8.56921 5.26404 +7353 6 28.6823 41.7982 21.1955 47.2047 1.42594 -8.59686 +7354 4 29.177 0.720645 21.3267 -21.6507 -0.473723 0.486784 +7355 4 29.4617 41.2314 21.0003 -26.4876 -3.65191 3.02858 +7356 6 11.643 12.3982 35.4482 -35.2927 22.3423 -20.2863 +7357 4 11.5968 12.2307 36.3713 6.75035 -5.55932 30.2124 +7358 4 12.5522 12.401 35.2267 32.0712 -2.0845 -6.40416 +7359 6 9.80556 12.056 0.297197 42.0735 31.0338 -28.3715 +7360 4 10.6577 12.4693 0.65483 -33.0881 -22.384 -10.4034 +7361 4 9.20254 11.76 0.941289 -12.1624 -10.8407 36.4861 +7362 6 48.1632 12.393 9.2137 2.43833 7.21341 -5.5951 +7363 4 48.4522 11.811 8.50685 -9.57081 -7.25037 -8.94466 +7364 4 48.8896 12.3474 9.83523 7.41749 2.43397 12.8852 +7365 6 20.1331 24.378 18.9556 11.9182 2.36756 -38.9603 +7366 4 19.4372 23.8368 18.5171 17.2732 8.77886 9.60074 +7367 4 20.7988 24.6336 18.2364 -23.7637 -10.2166 26.3276 +7368 6 16.5494 31.2838 16.4573 -15.9423 3.69088 33.2062 +7369 4 16.5519 32.1922 16.7594 11.1434 16.9832 -11.781 +7370 4 16.1476 30.8867 17.2522 1.55385 -15.8871 -15.2552 +7371 6 1.78983 14.6435 36.2904 4.99553 5.58283 2.2492 +7372 4 1.04893 14.2282 35.8708 -13.8588 -3.35469 -16.6141 +7373 4 1.66905 14.392 37.2023 2.39459 2.07051 19.2387 +7374 6 4.37166 29.2153 29.5914 5.79168 20.1405 -19.3585 +7375 4 4.91557 28.7254 30.2154 7.17051 0.117226 5.39869 +7376 4 4.91513 29.9512 29.1891 -14.7291 -26.607 12.32 +7377 6 43.6969 0.237019 22.6594 -7.19613 -4.49497 -5.57098 +7378 4 43.0237 0.783547 22.2316 -12.2242 -6.81623 2.03469 +7379 4 43.4415 41.2053 22.5454 5.15142 14.113 -1.35906 +7380 6 52.5052 40.9917 27.2414 -4.0762 -16.2903 -30.037 +7381 4 52.8129 40.7577 26.3208 -10.5132 10.5144 20.9332 +7382 4 53.295 41.2999 27.6882 6.37269 9.42971 1.77711 +7383 6 25.5785 23.9088 27.7352 -29.163 -0.147769 2.09076 +7384 4 24.7169 24.3904 27.6009 26.0068 -16.0483 4.45096 +7385 4 26.303 24.4711 27.4736 4.98376 5.99744 -3.44082 +7386 6 23.1322 17.0409 33.3147 -4.87562 4.34963 6.5261 +7387 4 23.1435 17.5188 34.1474 -0.665908 -2.26574 -1.07751 +7388 4 22.9237 16.1327 33.5379 -5.85649 -9.89669 4.05086 +7389 6 2.9235 11.8719 21.3628 -62.5775 -31.8178 -28.2901 +7390 4 2.1985 11.2347 21.6738 31.4392 30.9604 -16.9464 +7391 4 3.51176 11.9111 22.066 35.7266 4.49799 37.8533 +7392 6 2.17958 4.14491 30.0321 9.06251 -9.53771 -13.2585 +7393 4 2.15165 5.09682 30.107 -1.56529 16.7016 0.150815 +7394 4 2.7299 3.97467 29.2422 -7.5281 0.377543 4.10315 +7395 6 26.6694 30.2855 13.4776 10.1196 11.7228 27.7054 +7396 4 25.7357 30.4785 13.6549 -0.51692 -11.2356 -3.98914 +7397 4 27.0778 30.3597 14.373 -6.55394 -4.70072 -25.9179 +7398 6 24.8731 30.8123 10.8246 -35.9544 -8.06722 -7.65859 +7399 4 25.2097 30.0125 10.4324 5.41746 -9.73411 -7.41209 +7400 4 25.6149 31.228 11.1936 31.2673 18.7081 18.3938 +7401 6 53.1638 24.1184 4.51161 -10.4445 -35.9395 21.0824 +7402 4 53.5233 24.7957 3.98549 14.2054 30.1141 -21.0763 +7403 4 53.9237 23.6117 4.81383 2.71167 2.31883 7.09562 +7404 6 24.8958 4.51213 23.9931 -29.6363 -43.6073 15.3227 +7405 4 24.1339 5.1036 23.9039 18.5944 16.8193 -2.99678 +7406 4 25.7258 4.88904 23.7461 22.8138 27.5954 -9.18982 +7407 6 34.6838 1.65591 41.2514 12.8053 -23.083 -29.6978 +7408 4 35.6244 1.45761 41.0729 -14.4971 0.421146 -0.177754 +7409 4 34.7301 1.99199 0.211928 -2.47028 17.9107 34.9925 +7410 6 13.312 19.5249 16.387 18.9594 -19.3284 17.3248 +7411 4 13.9333 19.1674 15.7225 -9.24732 -4.9188 0.52103 +7412 4 13.2597 18.8166 17.0929 -3.23838 18.5958 -24.3952 +7413 6 48.698 0.181353 20.409 -0.21633 -26.9433 -24.4133 +7414 4 49.103 41.5184 19.698 -4.34753 24.5911 30.5043 +7415 4 48.7986 41.623 21.2469 8.80211 1.41451 -0.511645 +7416 6 43.0644 27.7916 11.5133 -14.5871 -6.12813 -9.0892 +7417 4 42.6 28.0105 10.6776 10.2055 -1.97818 11.3293 +7418 4 43.4908 28.591 11.8257 3.55806 4.66568 -1.20709 +7419 6 25.6909 21.365 35.1834 16.6334 21.4278 -26.2382 +7420 4 25.8486 22.0441 34.4664 -6.54449 -15.4554 28.1071 +7421 4 25.5413 20.5536 34.6727 -4.24699 7.33591 15.2905 +7422 6 44.7232 4.60607 27.7619 9.66663 0.618053 -4.25407 +7423 4 44.3234 4.00717 27.1079 -6.11804 2.34462 0.765623 +7424 4 44.3971 5.50639 27.5932 -3.06611 -6.30885 -0.545657 +7425 6 41.2897 11.4432 34.2066 -9.61739 21.0206 -8.56292 +7426 4 40.6842 11.5664 33.4581 3.14959 1.41378 -1.0752 +7427 4 41.1924 10.5195 34.3892 0.589219 -23.8889 7.33677 +7428 6 19.897 36.6492 2.04794 -32.5825 5.5481 -21.6378 +7429 4 20.6399 36.2361 2.4987 10.0826 10.558 0.716761 +7430 4 19.9026 37.6342 1.97212 14.9366 -15.8518 15.2433 +7431 6 27.4836 4.66736 6.35028 2.97665 -65.4375 -50.0742 +7432 4 27.6123 3.82169 6.79207 -3.46759 -4.72632 -9.32934 +7433 4 27.4741 5.24116 7.04108 -4.39889 64.7262 58.0755 +7434 6 16.8382 30.7844 39.9326 10.6925 -56.0648 15.7324 +7435 4 17.0186 31.2572 40.7403 -2.33579 15.7179 12.0581 +7436 4 17.0831 29.8382 40.1617 -5.04661 27.4351 -11.6424 +7437 6 51.1641 15.1933 16.3324 21.7581 16.0625 -9.079 +7438 4 51.121 16.0888 15.8936 10.5188 -25.5533 9.6052 +7439 4 52.0677 14.7794 16.1385 -37.3149 17.1399 3.28502 +7440 6 49.9904 21.2241 35.9744 20.9503 -33.7397 19.542 +7441 4 49.3714 21.5088 35.3291 -23.4605 10.1211 -23.8745 +7442 4 49.9121 20.2362 36.0002 2.40052 26.2853 0.00810801 +7443 6 34.428 0.14016 5.66944 -7.82493 37.3161 8.31948 +7444 4 34.304 0.843366 6.34479 2.68801 -11.9822 -16.4886 +7445 4 34.2591 0.582485 4.80419 9.04141 -16.6905 11.7821 +7446 6 48.3182 11.536 19.8764 -48.9228 13.3726 26.2823 +7447 4 47.7285 11.3649 20.663 34.2262 -2.74449 -19.9886 +7448 4 47.7235 12.1441 19.3775 23.4884 -14.873 -2.11476 +7449 6 4.19152 39.4305 13.3555 27.463 28.0369 44.5079 +7450 4 4.88401 39.7456 14.019 -21.6239 -15.7277 -33.754 +7451 4 3.37287 39.6897 13.8148 -3.76347 -10.7833 -11.4512 +7452 6 8.74995 16.191 8.53596 -5.05856 2.64204 -21.058 +7453 4 8.7323 16.8633 9.22906 0.669847 -0.203387 -6.91741 +7454 4 8.69158 16.6347 7.64451 3.76071 -7.46014 24.9197 +7455 6 29.0285 14.2822 26.5262 -5.84817 34.0816 17.5192 +7456 4 29.0044 15.2824 26.745 3.30971 -49.1818 -9.92417 +7457 4 28.1563 13.9159 26.7584 2.39554 12.59 0.416474 +7458 6 27.3852 14.5292 8.14264 -25.3608 8.37865 0.80053 +7459 4 26.4121 14.3996 8.08331 21.4517 0.6706 1.76752 +7460 4 27.495 15.4908 8.29449 3.73212 -17.2528 -1.50339 +7461 6 14.1265 27.2071 32.922 33.1666 19.82 -10.1122 +7462 4 14.9257 27.349 33.4618 -9.56175 -2.66902 -6.75133 +7463 4 13.49 26.8422 33.5082 -21.5238 -13.7689 15.9353 +7464 6 31.6534 35.7886 21.2701 -36.804 -37.663 0.546332 +7465 4 32.1208 36.3742 21.8378 9.4961 28.0075 13.3964 +7466 4 30.8651 35.4592 21.7961 25.8489 11.2411 -16.1565 +7467 6 54.2152 28.7064 16.8886 2.86275 11.2554 8.9719 +7468 4 53.522 28.534 16.2345 -0.160695 -4.94794 5.34414 +7469 4 54.0581 29.6054 17.2296 -4.68599 -7.1814 -6.41975 +7470 6 9.06113 5.28333 17.1437 22.8853 4.22723 -20.1716 +7471 4 9.91678 5.17464 16.6036 -37.1561 0.754494 23.2593 +7472 4 8.77829 6.22091 17.0709 7.89423 -13.2605 2.73354 +7473 6 29.6746 9.78112 26.5507 33.4729 -21.3737 16.6755 +7474 4 30.5187 9.26436 26.5785 -19.9088 14.0899 -1.39861 +7475 4 29.3838 9.79264 27.4752 -2.64272 0.36338 -0.771294 +7476 6 44.0224 31.1718 32.1785 -15.3292 -7.28341 -3.2168 +7477 4 43.2245 30.9732 32.7283 18.2556 6.42044 -7.39667 +7478 4 44.6106 31.7763 32.6435 0.791193 1.46174 13.5451 +7479 6 53.5017 3.62335 25.1421 -16.9806 -9.67341 -1.19546 +7480 4 54.1073 4.37139 25.2408 5.33888 -0.871569 -8.36925 +7481 4 53.4976 3.25444 24.2353 14.6771 10.8199 10.1585 +7482 6 12.4523 22.8699 3.37515 20.8696 32.0548 51.3092 +7483 4 12.8715 22.0381 3.24611 3.69599 -28.8916 -15.1378 +7484 4 11.7545 23.0169 2.77653 -28.9409 -2.61743 -32.5554 +7485 6 39.4163 29.6883 0.716973 23.965 14.7498 -4.51132 +7486 4 39.9876 29.0776 0.254063 1.0023 1.05593 -7.22278 +7487 4 38.7356 29.138 1.03498 -27.9991 -12.2746 11.9106 +7488 6 13.7523 37.8126 23.0391 19.0421 33.8918 15.0049 +7489 4 14.5819 38.1972 23.3968 -5.92503 -31.5844 -9.82397 +7490 4 13.2717 38.649 23.0641 -23.8611 -10.9328 -14.9892 +7491 6 33.3489 41.2294 0.00543 12.0778 19.0207 4.12226 +7492 4 33.8966 0.076279 41.545 -17.8654 -16.3366 26.9287 +7493 4 33.5442 41.0956 0.968664 -4.79835 4.63337 -24.688 +7494 6 15.7246 3.52046 6.32841 10.9162 -8.85937 41.3038 +7495 4 14.9211 3.23468 6.78447 -0.787572 2.77727 3.3355 +7496 4 15.4617 3.69817 5.45032 -11.5336 7.63209 -33.5323 +7497 6 27.7759 30.762 5.08277 5.52432 -34.0682 -16.3389 +7498 4 28.5998 30.6312 5.57248 -10.7862 7.58152 2.34054 +7499 4 27.6688 29.856 4.68367 -5.5152 22.3618 6.77689 +7500 6 13.3283 7.58248 23.3427 28.3072 -1.43357 14.0598 +7501 4 14.1858 7.86415 22.9596 -10.8574 -4.57961 9.77565 +7502 4 12.7328 7.50745 22.6198 -18.1881 0.025746 -17.8687 +7503 6 38.3062 37.3234 27.9933 -3.63803 -3.21002 47.0561 +7504 4 38.1692 37.3862 27.0673 7.32148 -0.46048 -39.7323 +7505 4 39.0245 36.7163 28.2248 2.26391 -1.88339 -8.27891 +7506 6 35.8197 12.5511 12.093 -4.81482 -18.6185 14.0356 +7507 4 35.6024 11.6096 12.0486 2.81432 1.21601 -0.921604 +7508 4 36.2712 12.7262 11.2865 10.3444 9.98072 -18.0035 +7509 6 52.1161 23.0926 41.2793 27.7225 -3.87143 -59.8556 +7510 4 52.4049 23.0393 40.2964 5.44511 3.0042 51.4604 +7511 4 51.1968 22.9093 41.149 -26.7248 -2.75497 17.7375 +7512 6 39.5495 11.6692 16.6079 -1.17202 -14.5197 -14.1262 +7513 4 39.7784 10.7494 16.7482 7.99576 -7.98247 -12.1867 +7514 4 39.4663 11.9292 17.5115 -4.38422 20.0879 20.6825 +7515 6 0.676885 9.01905 7.96736 13.1741 22.7352 -22.4375 +7516 4 54.8016 8.92404 8.29683 -40.226 7.08621 2.19233 +7517 4 1.10058 8.31451 8.38908 28.7575 -30.4684 16.9583 +7518 6 42.3311 28.7401 39.4661 13.4879 80.877 11.2525 +7519 4 41.6603 28.5849 40.0851 -34.7426 -11.2721 27.5092 +7520 4 42.5519 27.921 39.1558 20.2132 -66.4303 -37.3003 +7521 6 38.7411 30.2829 16.2738 12.7671 5.32399 18.4704 +7522 4 38.9183 29.8748 17.1496 -6.87016 4.31697 -11.6029 +7523 4 39.4059 31.0046 16.2472 -14.9795 -12.5163 -3.03567 +7524 6 7.58764 18.0405 0.648325 -47.6574 -19.7672 20.3632 +7525 4 7.12731 17.6217 1.42737 12.1211 9.19751 -27.5752 +7526 4 8.47251 18.0259 0.938181 42.7013 4.4664 8.86021 +7527 6 33.7296 34.5938 24.1405 -3.484 -2.51034 -8.30179 +7528 4 33.5251 35.3309 23.5532 1.13599 -1.72579 4.26838 +7529 4 33.8994 34.9649 25.0137 6.47563 -1.63099 1.09862 +7530 6 16.0166 40.0494 39.5956 -28.3908 0.329345 -1.37751 +7531 4 16.9382 40.2323 39.4336 17.0381 0.329941 -6.23981 +7532 4 15.5262 40.0524 38.7513 12.3223 -0.591958 2.13513 +7533 6 4.49229 37.1333 21.8385 27.3085 -52.2253 -58.5501 +7534 4 4.66683 37.716 22.5264 18.8147 38.5231 40.56 +7535 4 5.37915 36.8768 21.3985 -41.7208 12.465 14.7942 +7536 6 39.2691 20.1288 31.3316 -12.2203 -9.20146 -18.9279 +7537 4 39.1503 20.9416 31.8094 1.95478 16.2675 16.373 +7538 4 38.6746 20.1785 30.5607 4.99665 9.53371 7.24081 +7539 6 28.5508 6.16368 32.0494 2.8072 -5.52183 -6.01527 +7540 4 29.3622 6.49582 32.4253 9.65206 -4.8896 7.96618 +7541 4 28.0782 6.98121 31.874 -4.3704 -0.58129 1.95425 +7542 6 9.33595 11.3298 38.1871 -32.8874 9.84086 11.8913 +7543 4 8.64445 12.0594 38.2922 21.8008 -26.7714 -10.0524 +7544 4 8.88851 10.5546 37.784 7.69784 20.5749 -6.72048 +7545 6 41.6095 10.4782 6.86111 8.23897 -6.62675 34.9169 +7546 4 41.7694 10.1037 7.78655 -4.1265 15.4661 -32.721 +7547 4 41.7821 11.4382 6.90291 -3.49967 -11.9299 -5.09907 +7548 6 3.12867 28.1157 17.6206 15.6267 -45.6796 29.9202 +7549 4 2.63816 28.6493 17.0564 -29.7899 29.6493 -43.0934 +7550 4 3.59757 28.7421 18.155 7.53462 9.15161 11.5693 +7551 6 39.3499 12.2397 19.2529 -23.7838 14.9837 13.9357 +7552 4 39.2457 13.2286 19.3464 7.91877 -27.4185 3.68816 +7553 4 38.6075 11.8387 19.7677 15.6586 5.94778 -12.3856 +7554 6 2.78491 9.11686 31.712 -26.5503 -22.4732 34.9375 +7555 4 3.2978 8.41451 32.2045 -9.27186 19.8876 -17.5091 +7556 4 3.27525 9.5282 31.0263 27.6548 6.40843 -16.0242 +7557 6 47.0993 34.3062 24.1668 40.213 25.5871 3.96938 +7558 4 47.8652 34.9011 23.9742 -8.40565 -28.0457 9.8184 +7559 4 46.4391 34.8642 23.795 -37.1496 -1.08965 -6.28687 +7560 6 41.29 35.6184 9.54316 -30.0867 29.8286 7.21591 +7561 4 40.3249 35.7138 9.72984 17.4159 -14.0538 -3.31523 +7562 4 41.5907 36.542 9.70742 6.71087 -21.892 -10.0971 +7563 6 20.4656 31.4513 3.14505 -29.4444 2.15246 21.5865 +7564 4 20.9799 31.2087 3.9226 8.79014 -0.482357 -2.15716 +7565 4 19.5517 31.5947 3.51954 23.5031 -1.57475 -20.844 +7566 6 33.2192 17.965 24.7971 19.8065 25.0952 18.1835 +7567 4 34.1598 18.0267 25.093 -16.2559 -11.4614 -7.96855 +7568 4 32.9244 18.9016 24.8301 -6.14071 -21.8705 -2.46334 +7569 6 40.1545 39.892 35.7566 -26.4952 1.03865 35.1005 +7570 4 39.554 39.7115 35.0283 3.12548 3.08468 -2.58895 +7571 4 39.5538 40.0617 36.55 23.7339 -1.54775 -30.4418 +7572 6 4.86493 34.7165 16.5037 -1.18866 4.83191 -8.79653 +7573 4 4.98021 35.6639 16.3239 -2.48039 -7.07182 -3.79473 +7574 4 5.57973 34.27 16.0245 9.17482 -2.77359 5.31354 +7575 6 19.1203 11.0308 26.5475 4.8369 12.9311 -1.38474 +7576 4 19.2948 10.8261 25.6303 -10.7878 -2.53157 -9.81197 +7577 4 19.6222 10.3806 27.0285 -0.932765 -12.0852 11.9627 +7578 6 54.013 13.9266 34.7866 19.735 -12.4153 18.0126 +7579 4 53.1377 14.0488 35.1524 -10.4928 -1.09871 -13.0068 +7580 4 53.982 14.1469 33.8595 -3.66316 10.2302 -11.2602 +7581 6 1.83695 20.649 5.20524 25.5491 14.9074 -17.0883 +7582 4 1.35705 19.8566 4.90021 2.5306 9.60758 -2.11708 +7583 4 2.48138 20.9466 4.48633 -27.5057 -15.388 16.1855 +7584 6 22.2484 0.089789 14.2543 15.3573 -11.1234 0.0573231 +7585 4 21.4821 0.622149 14.4313 -9.66168 8.29964 10.305 +7586 4 22.7606 41.8363 15.0657 -14.7435 5.42194 -5.09127 +7587 6 4.9437 7.03924 24.7311 13.2528 -2.19763 7.32506 +7588 4 4.13251 7.3412 24.2993 4.98795 -3.92941 -4.4547 +7589 4 5.31694 6.26419 24.274 -9.7854 5.58222 5.45409 +7590 6 41.4768 20.8727 34.9433 -10.8141 32.3245 17.6117 +7591 4 42.0721 20.1596 35.0936 18.2074 -21.2429 -2.25611 +7592 4 41.5511 21.3995 35.7803 -3.93981 -14.5735 -18.4651 +7593 6 28.2063 1.73787 31.7361 2.56856 -6.63991 -21.6427 +7594 4 27.5833 1.04583 32.0206 5.931 11.5306 2.70007 +7595 4 28.427 2.28487 32.4907 -6.15569 2.19681 12.1249 +7596 6 16.8959 27.3728 36.9936 3.36683 -9.46076 -21.7251 +7597 4 17.1861 28.0765 36.4018 -0.835984 6.87178 9.62195 +7598 4 17.1491 26.5677 36.4964 -8.72142 5.45523 11.8618 +7599 6 26.8172 38.095 8.33253 -7.04389 15.4319 43.7153 +7600 4 26.4231 38.1886 9.22965 13.1827 16.4204 -18.9623 +7601 4 26.752 37.1697 8.26194 2.82704 -45.8494 -18.5449 +7602 6 26.6605 33.8021 23.2109 -14.7721 -8.40788 6.86704 +7603 4 27.1437 33.2455 22.6071 1.71839 -3.83047 -13.3917 +7604 4 27.3181 34.0928 23.8234 13.6598 11.6313 12.8928 +7605 6 10.2089 27.1103 30.2249 26.5091 -20.839 -19.8889 +7606 4 10.2296 28.0525 30.305 -4.35446 23.414 7.17464 +7607 4 10.909 26.9135 29.5485 -17.3927 5.996 19.4297 +7608 6 47.8678 12.6068 5.01236 10.3402 17.2727 14.3835 +7609 4 48.2471 13.4466 5.34357 -15.5974 -13.1618 -9.91905 +7610 4 48.2827 11.9587 5.58273 0.760146 -12.24 2.37579 +7611 6 53.3401 24.5564 22.1447 -33.4845 3.13007 15.4457 +7612 4 53.2868 24.6175 23.1082 -8.50106 -5.88574 1.47389 +7613 4 54.2491 24.6404 21.954 37.9576 4.9603 -12.0283 +7614 6 29.4115 10.751 19.3682 47.3718 16.1602 -3.46693 +7615 4 29.23 9.95501 18.9095 -1.62259 -22.6341 -18.5903 +7616 4 28.6164 10.8767 19.816 -47.8248 15.8998 30.722 +7617 6 39.4772 14.9486 19.552 50.4126 11.9025 42.2912 +7618 4 40.3976 15.2789 19.8627 -47.7598 -21.1435 -8.50237 +7619 4 39.4723 15.2512 18.6704 -12.4406 15.8155 -35.6919 +7620 6 32.8813 15.9868 22.8125 3.47488 17.0872 -31.9433 +7621 4 33.0166 16.4922 23.6113 -1.39335 7.20309 14.6349 +7622 4 32.7144 15.0846 23.0256 -4.37432 -22.045 19.0968 +7623 6 30.558 1.96704 21.5074 2.70654 -4.91402 -0.473851 +7624 4 30.6739 2.00523 22.4671 5.88049 3.20632 -1.97238 +7625 4 31.3728 1.59666 21.1136 -11.8747 6.17773 7.16567 +7626 6 0.976021 12.0022 3.31788 -2.33791 2.9975 -11.3542 +7627 4 1.23381 12.945 3.27167 -8.13702 -10.1344 5.41434 +7628 4 1.05317 11.6593 4.21576 7.83216 6.74936 8.77967 +7629 6 32.1417 30.4028 20.7928 -10.9162 7.90477 -12.8705 +7630 4 32.9583 30.6218 20.3315 4.32484 3.35409 -0.814586 +7631 4 31.4267 30.7883 20.2371 10.7836 -11.8724 10.7529 +7632 6 5.37233 35.5196 8.9984 1.65786 -0.655334 17.0686 +7633 4 5.15633 35.7733 8.10502 -8.52999 -6.98357 -10.434 +7634 4 4.86772 34.7263 9.2434 -1.9757 2.02155 -6.9424 +7635 6 49.9125 13.0387 32.1973 27.4626 15.6741 -16.8517 +7636 4 50.6053 12.9182 31.4733 -26.2683 -0.306922 26.3637 +7637 4 49.2504 12.3613 32.0764 -3.75185 -11.6573 -0.304044 +7638 6 4.31386 24.093 1.57868 7.45772 -24.8618 -14.5348 +7639 4 3.64218 24.7342 1.7864 -13.9986 8.43803 -2.25361 +7640 4 4.01488 23.4668 0.872394 2.3276 24.3041 16.4513 +7641 6 44.1644 38.1215 12.3455 -22.0907 -25.3739 20.9172 +7642 4 43.5152 37.5597 12.8481 16.1408 4.83783 -17.5332 +7643 4 43.8688 38.9961 12.5721 5.21907 21.319 -3.3764 +7644 6 44.6817 17.3326 22.8013 48.0619 -4.56356 -9.07637 +7645 4 45.2902 18.0584 23.1498 -22.5072 -22.7727 -5.21409 +7646 4 45.2932 16.6008 22.4593 -20.015 30.0459 19.1644 +7647 6 20.3678 11.7042 19.6638 18.1083 -41.9451 -24.672 +7648 4 19.8947 12.3606 20.1264 -14.0753 36.8205 14.9866 +7649 4 20.5011 12.0109 18.7433 -0.799123 0.72776 10.7716 +7650 6 4.45477 15.3976 36.1886 1.65809 1.26145 11.9226 +7651 4 5.09661 14.6681 36.098 -4.75494 5.61497 -10.92 +7652 4 3.56051 15.0123 36.2095 4.93474 0.57137 -3.51241 +7653 6 44.8032 39.5214 30.1736 10.2403 3.65831 -28.7798 +7654 4 44.6649 39.352 29.2044 0.893291 -3.4354 28.9244 +7655 4 44.1834 39.0261 30.7164 -9.9549 -0.503639 -4.51595 +7656 6 30.0776 3.52093 11.3186 -8.111 -9.63673 -5.93937 +7657 4 30.5797 4.33725 11.0789 -10.9699 -19.7375 -4.73534 +7658 4 29.9808 2.85663 10.5812 14.022 21.906 10.2093 +7659 6 25.6241 24.8658 16.1333 6.68449 -9.57605 -29.1286 +7660 4 26.5694 24.8046 15.8818 -8.72523 1.1772 17.1704 +7661 4 25.5267 25.1318 17.0381 12.8553 5.85519 26.3055 +7662 6 36.8177 29.8487 20.6561 -37.5479 -3.0004 33.0202 +7663 4 35.926 30.1959 20.4157 18.2985 -1.907 -0.407745 +7664 4 36.6716 29.3784 21.5423 12.7247 15.2026 -39.3319 +7665 6 52.2186 17.0658 38.3042 -7.89215 -38.4825 28.5148 +7666 4 51.4916 16.4675 38.6484 24.7832 21.5941 -14.95 +7667 4 51.8247 17.6139 37.6469 -10.8917 8.73986 -12.7264 +7668 6 3.82879 23.6249 29.8747 0.0111461 24.9347 -0.194649 +7669 4 4.57266 23.2964 29.3507 7.82142 7.55197 5.89536 +7670 4 4.12107 24.4472 30.3626 -2.93665 -31.334 -6.69289 +7671 6 6.37221 19.8955 41.0814 -10.7405 10.6187 0.232117 +7672 4 6.67124 19.2607 41.7286 9.67887 -12.4754 3.81392 +7673 4 6.49825 20.7419 41.4991 -1.14685 10.1205 10.9238 +7674 6 28.9128 38.9237 35.3305 22.4394 21.6131 25.3888 +7675 4 28.4594 38.2476 34.8641 -13.9867 -26.2755 -20.0992 +7676 4 29.711 38.4973 35.7105 -10.7836 3.83713 -8.57645 +7677 6 1.06675 30.3059 34.4729 25.4378 -4.31804 35.0042 +7678 4 0.780778 29.8064 33.7399 -5.76855 -22.7951 -38.2413 +7679 4 0.490797 31.0506 34.5199 -18.1513 16.5028 -0.872558 +7680 6 26.4359 22.0299 20.4363 32.8101 13.5123 0.44111 +7681 4 27.364 22.3315 20.3938 -13.8894 -16.1779 0.0777322 +7682 4 25.9647 22.8561 20.3336 -19.4369 -2.2953 -2.32927 +7683 6 3.94837 18.6341 22.6823 32.7056 -17.0211 23.8668 +7684 4 4.7768 18.6814 23.2391 -24.3494 -8.73456 -16.7413 +7685 4 3.72444 19.5457 22.6416 -13.4357 33.3979 -9.86072 +7686 6 6.89585 39.3162 26.9832 -46.5714 7.68979 7.72716 +7687 4 6.93923 40.0377 27.612 28.7888 3.33438 12.9127 +7688 4 5.92214 39.2413 27.0287 16.4173 -5.75108 -11.0421 +7689 6 43.9872 41.7521 26.5322 17.8857 -12.0416 -16.5154 +7690 4 43.9509 0.2718 27.3768 -8.40653 9.77536 19.5266 +7691 4 43.1315 41.809 26.1188 -22.0408 9.50446 -3.00799 +7692 6 31.7113 29.5746 16.987 -20.6637 1.93471 5.13032 +7693 4 31.02 28.863 17.0135 12.5534 15.6398 -7.64726 +7694 4 31.2508 30.4156 17.2234 10.2038 -24.3383 2.42367 +7695 6 46.2561 10.9612 15.5385 0.577538 -38.7584 22.3134 +7696 4 45.3251 10.7213 15.4484 -5.02058 7.03855 -0.171485 +7697 4 46.6569 10.0824 15.7727 -2.20865 28.2857 -11.3723 +7698 6 36.5827 15.0435 25.8168 31.2067 4.61936 9.12499 +7699 4 37.3875 15.5118 26.1911 -33.209 -18.98 -14.6655 +7700 4 36.1295 14.6889 26.5897 -4.0863 -6.05063 3.58839 +7701 6 47.2722 22.6647 6.13576 -8.17133 27.0247 -35.749 +7702 4 46.6204 23.3224 5.77393 14.8224 -22.4366 13.8178 +7703 4 46.9842 22.4705 7.01441 -4.98592 -2.25738 16.061 +7704 6 27.5378 39.6651 17.8024 -2.94112 10.9701 -10.3343 +7705 4 26.5953 39.7232 17.618 -8.53785 1.10642 -8.0722 +7706 4 27.5664 39.1005 18.5557 5.38052 -12.9364 18.2146 +7707 6 14.0357 27.9675 36.8848 11.7171 -39.9071 2.25396 +7708 4 13.4367 27.1833 36.8225 11.7441 28.4062 -4.63591 +7709 4 14.9372 27.5486 36.8957 -17.1932 18.8386 1.76957 +7710 6 33.7684 13.0304 13.8649 26.1794 -24.2655 -33.187 +7711 4 34.6252 12.938 13.363 -28.3858 22.7045 20.1179 +7712 4 33.4338 12.1329 13.7478 -6.61414 4.24237 14.4002 +7713 6 3.3826 17.477 1.97134 -12.4208 -32.1468 -36.6933 +7714 4 2.99872 16.7111 1.40376 19.9781 39.313 29.0042 +7715 4 3.44044 18.2025 1.33186 0.336883 0.1642 8.16047 +7716 6 27.5407 2.76347 36.4361 37.1152 10.6125 -5.75272 +7717 4 28.1274 2.95293 35.6781 -8.18971 -2.06925 12.0999 +7718 4 26.7696 2.41682 36.0063 -15.232 -6.73967 7.66134 +7719 6 21.3092 1.20818 18.7198 27.6808 -56.7894 17.4302 +7720 4 20.9088 2.03925 18.6129 -17.8717 42.912 1.2548 +7721 4 21.1846 0.863131 19.6413 -10.5106 12.8119 -18.3621 +7722 6 11.8887 16.6751 29.3062 -13.3787 -14.7829 9.57092 +7723 4 10.9992 16.5416 28.8882 19.0949 3.10928 11.6713 +7724 4 11.8781 16.1991 30.1864 -3.15773 18.3703 -25.9576 +7725 6 15.9606 29.4505 29.6321 19.1231 40.0535 19.8704 +7726 4 16.8787 29.2659 29.409 -1.79459 -0.812108 -5.15406 +7727 4 16.0576 30.3074 30.1528 -10.887 -31.0851 -11.0284 +7728 6 42.9296 7.03459 4.51333 33.3286 4.63812 8.33203 +7729 4 43.4321 7.52085 3.82302 -14.3213 -8.56549 9.51251 +7730 4 43.6462 6.74019 5.1384 -26.8219 -5.28882 -15.1101 +7731 6 46.4281 26.3352 18.5118 -29.5226 20.9834 -10.3716 +7732 4 46.6343 27.1839 18.9751 -0.829481 -30.2492 -9.82569 +7733 4 45.6684 26.5824 17.9287 20.9241 -8.5113 7.46212 +7734 6 26.8394 31.9326 30.1088 25.5924 -16.6135 -32.4851 +7735 4 27.2107 31.0232 29.8435 -20.3392 35.4128 12.4615 +7736 4 26.6802 32.4017 29.2373 1.48159 -21.8349 29.7067 +7737 6 19.4878 37.6142 31.2562 -14.4543 3.58951 24.8148 +7738 4 19.156 36.8698 30.7235 -3.28844 3.66685 11.8368 +7739 4 19.1019 37.6358 32.1884 8.87174 -10.6544 -29.6345 +7740 6 52.3726 32.7139 12.8078 14.0751 37.5782 -32.6023 +7741 4 51.9367 33.0602 12.0031 -5.44932 -19.1877 9.81768 +7742 4 53.2329 33.1776 12.7347 -13.6236 -17.9256 14.0183 +7743 6 6.74161 9.28353 24.0307 -13.1667 -36.0519 9.75632 +7744 4 6.38029 9.61276 23.1997 0.718458 -3.76261 -6.90188 +7745 4 6.16941 8.51095 24.2946 11.6474 19.2019 -8.42102 +7746 6 39.7455 39.5612 25.4988 -8.346 1.54154 -0.59194 +7747 4 39.7035 38.6168 25.2826 0.975023 6.38379 0.651723 +7748 4 38.8484 39.7767 25.8082 2.0142 -6.85885 -0.770105 +7749 6 24.0762 14.0053 21.1456 13.3165 -18.5501 -35.6859 +7750 4 23.5798 13.5675 21.8237 -9.9014 -1.44375 19.5869 +7751 4 24.3047 13.2647 20.5221 -3.72657 29.1491 15.9401 +7752 6 5.19759 41.7876 24.8616 10.5329 -30.3401 13.9713 +7753 4 5.96107 0.070496 25.4117 5.01198 -1.48177 -8.04364 +7754 4 4.80364 0.70791 24.6471 -6.87058 19.426 -10.6286 +7755 6 42.3635 20.8692 21.2747 32.7502 -34.6644 -10.1673 +7756 4 42.4242 20.4785 22.1458 -3.583 2.66194 10.2144 +7757 4 41.7418 21.5604 21.318 -29.6652 28.4695 2.24145 +7758 6 48.2477 15.3659 33.5923 1.80889 -1.28345 12.5443 +7759 4 48.6164 14.6993 32.9992 0.330488 0.612282 -4.05403 +7760 4 47.6342 15.9182 33.1009 -4.13716 0.340872 -13.8372 +7761 6 46.021 38.2915 16.5867 23.3569 13.4435 24.034 +7762 4 46.6714 37.7063 17.0526 -15.1447 15.3639 -15.4724 +7763 4 46.2171 39.2064 16.9307 -10.1858 -20.2136 -16.2853 +7764 6 4.64649 28.484 21.3661 -49.4423 -36.8464 -34.122 +7765 4 5.0061 28.857 22.1388 17.5694 9.2675 37.6073 +7766 4 4.11403 27.6656 21.6036 24.8595 24.6655 -3.1651 +7767 6 20.5601 15.1658 18.389 17.6685 -18.4833 12.4376 +7768 4 20.0269 15.9148 18.1339 -10.4277 9.01273 0.992097 +7769 4 20.1375 14.696 19.1318 -1.87864 11.9594 -2.12399 +7770 6 16.2536 13.648 17.4664 -31.6255 -3.12789 -19.3987 +7771 4 16.1444 14.6075 17.6118 2.65347 -13.1818 -8.15029 +7772 4 15.6032 13.3943 16.7283 22.0135 11.6863 31.5082 +7773 6 52.4969 30.9511 18.1582 10.5176 -22.8935 27.2955 +7774 4 52.1187 31.5845 17.5724 -17.5669 13.4893 -21.7562 +7775 4 51.7599 30.5669 18.6706 14.518 10.6779 -8.97027 +7776 6 24.417 1.73185 15.7818 -6.46311 -4.24469 33.4298 +7777 4 24.2563 1.19981 16.5985 3.98325 2.24538 -18.7421 +7778 4 24.1038 2.61269 16.0335 4.13298 0.832539 -9.96215 +7779 6 23.8696 5.09384 31.0808 18.8621 -40.8234 -26.8653 +7780 4 23.8491 5.89936 31.5593 0.144588 30.2314 14.3891 +7781 4 24.8063 4.82715 30.9043 -17.3015 12.7186 6.18451 +7782 6 29.664 30.9246 0.393748 19.8337 -4.81556 23.0674 +7783 4 30.503 30.586 0.018652 -21.3617 6.75777 -1.54054 +7784 4 29.144 31.3327 41.6109 -5.17979 -0.628515 -14.2195 +7785 6 32.8496 37.8945 22.5158 10.0753 4.77658 10.1953 +7786 4 33.692 38.178 22.1563 2.67507 -3.41774 -7.7275 +7787 4 32.953 38.1222 23.4459 -10.6691 2.21895 5.00606 +7788 6 16.4801 17.3789 33.7607 -9.23434 -4.14589 -23.771 +7789 4 15.9446 17.8653 33.093 7.5539 3.01496 23.5583 +7790 4 17.136 16.9338 33.2029 1.0053 3.7812 3.66748 +7791 6 9.22576 13.3955 27.544 21.8484 -6.91303 -4.28818 +7792 4 8.36976 13.4851 27.1157 -15.2219 0.444174 10.4645 +7793 4 9.14931 12.9772 28.4181 -9.36318 7.36421 3.71477 +7794 6 43.4776 7.7356 17.2334 -9.59035 3.82748 19.1182 +7795 4 43.4092 7.74545 18.2218 0.501649 1.62452 -33.0026 +7796 4 44.4173 7.85634 17.0579 0.99974 -1.57098 -4.99047 +7797 6 22.314 24.3423 23.1668 -12.6246 5.51695 -1.93377 +7798 4 22.7955 23.5193 23.2443 6.83464 -10.1031 3.26418 +7799 4 21.5276 24.1384 22.6266 3.35813 5.31764 3.82921 +7800 6 26.0086 32.9187 32.7195 -0.756619 6.65713 -1.20686 +7801 4 26.2515 32.7095 31.8047 -0.82286 -4.52018 -0.557583 +7802 4 25.2078 32.4163 32.9092 -2.81033 -0.378904 -0.617388 +7803 6 16.9305 19.0463 7.44765 14.0068 18.7364 -6.96389 +7804 4 16.3855 19.2981 8.21028 -2.47769 1.30563 -6.88861 +7805 4 17.0815 19.8512 6.87677 -9.59141 -23.4241 18.196 +7806 6 48.1118 14.458 27.5672 -1.70385 5.14823 10.3583 +7807 4 48.0423 15.1786 26.9235 1.90686 -4.78611 -1.19899 +7808 4 48.0875 14.8765 28.4507 4.89589 -0.740891 -11.823 +7809 6 52.3863 41.7399 11.1185 2.41988 14.2085 23.7397 +7810 4 52.3863 0.193993 10.2459 -4.45976 10.8931 -22.0542 +7811 4 52.6887 0.557857 11.7005 -5.56281 -10.4239 -7.84704 +7812 6 36.3311 6.93589 12.7094 -2.38398 9.53491 -1.97617 +7813 4 36.3789 7.90344 12.827 -2.48918 -10.7733 3.15906 +7814 4 37.2588 6.6822 12.6726 5.22435 -7.00461 -0.877062 +7815 6 8.24215 20.3216 16.6719 4.98767 -5.10439 -5.65687 +7816 4 8.08588 19.3952 16.4038 -4.3079 5.82994 10.8424 +7817 4 9.2046 20.4438 16.7199 -1.30961 -3.63404 -4.19262 +7818 6 28.7954 40.3113 12.828 -13.6179 6.23593 21.4452 +7819 4 29.5192 40.3706 12.2287 20.8327 -7.3113 -16.8089 +7820 4 28.5554 39.3777 12.9053 -3.26344 4.60902 -2.65931 +7821 6 18.1473 11.8343 16.9395 -0.80483 -16.2761 12.6256 +7822 4 17.6848 12.6388 17.2294 4.62203 -2.59462 -3.9508 +7823 4 19.0947 11.9922 16.9221 7.13726 16.095 1.27241 +7824 6 30.8869 17.4142 21.504 -52.7305 12.2285 -31.3088 +7825 4 30.1482 16.8222 21.1884 27.1221 10.2955 22.0665 +7826 4 31.6253 16.8731 21.7262 19.9221 -18.6281 13.9623 +7827 6 34.8012 19.4194 37.9626 16.1869 22.0253 -15.6613 +7828 4 34.8979 20.1386 37.2822 -2.41662 -18.1877 20.3873 +7829 4 34.2105 18.7604 37.6043 -6.15487 -8.04615 -10.7113 +7830 6 35.8208 16.8923 29.2032 22.3367 20.7443 33.8648 +7831 4 36.613 16.5252 29.6466 -9.20578 0.119567 -6.22754 +7832 4 35.5382 16.2441 28.5922 -11.4717 -30.451 -21.7041 +7833 6 3.04279 32.2854 6.33929 -26.9238 12.3825 -4.69033 +7834 4 2.12647 32.146 6.0594 1.42689 6.59766 6.64942 +7835 4 3.42261 31.4611 6.08203 25.9982 -20.506 -0.598367 +7836 6 26.7966 41.6596 10.1464 32.6739 -10.8326 9.81865 +7837 4 27.6955 41.4226 9.79016 -25.5431 4.71255 4.81996 +7838 4 26.9918 0.01593 11.0584 -5.4334 2.64263 -3.14356 +7839 6 52.266 24.562 24.8685 -9.42886 0.421982 -6.72882 +7840 4 51.3046 24.7615 24.9057 17.7877 -5.82089 5.23086 +7841 4 52.6568 24.8699 25.6923 -4.67896 5.24225 9.60646 +7842 6 22.6938 22.6511 33.5751 -3.71591 7.58927 38.5179 +7843 4 23.2073 23.1628 34.2375 -1.81825 -3.74423 -24.5931 +7844 4 21.9227 22.4274 34.1227 -1.3969 -6.37714 -14.1968 +7845 6 10.6508 14.2453 33.0462 38.3111 -19.1724 1.31243 +7846 4 10.5904 14.9583 32.4175 -11.7628 10.624 -9.61146 +7847 4 9.79743 14.0525 33.3881 -28.4056 0.15536 2.16046 +7848 6 21.8963 10.8464 11.5207 26.0054 2.65771 10.2946 +7849 4 22.8204 10.615 11.7238 1.04479 5.32162 -7.74354 +7850 4 21.5123 10.8483 12.397 -14.7134 -4.5627 10.8449 +7851 6 38.3602 6.02493 25.8481 -1.65407 -6.16467 0.326828 +7852 4 38.011 6.16356 26.7557 4.19059 11.4538 -13.8011 +7853 4 38.4332 6.8537 25.3449 -2.0709 2.94932 12.5244 +7854 6 30.9335 26.6426 38.5759 12.2579 -6.52521 -50.146 +7855 4 30.9725 26.4832 39.4983 -1.12433 -12.3748 34.5417 +7856 4 31.1634 25.7976 38.1184 -10.2303 12.0451 18.6771 +7857 6 30.1758 14.6176 35.4883 -28.0954 45.5198 -22.6945 +7858 4 30.377 15.4621 34.9933 16.3957 -28.3235 8.82257 +7859 4 29.2055 14.6893 35.4544 11.1506 -16.8188 10.9927 +7860 6 12.5393 37.2199 16.9523 -39.8589 -5.36999 -7.27655 +7861 4 12.8749 37.9509 17.4338 22.3846 22.4284 20.6781 +7862 4 13.1653 36.5135 16.9845 23.2041 -13.3789 -0.375674 +7863 6 27.4265 21.5607 37.7225 20.8747 -12.9562 -0.181201 +7864 4 26.9326 21.725 36.9211 -12.0211 3.79264 -7.84561 +7865 4 27.0206 21.994 38.4656 -12.5008 8.35973 2.85409 +7866 6 29.6119 18.3909 12.6766 5.02953 -16.5769 27.1188 +7867 4 29.5217 18.1084 13.6179 -1.01954 6.11509 -19.9302 +7868 4 28.7057 18.4542 12.3734 -9.03627 4.70036 -1.08008 +7869 6 2.35849 15.6559 0.172343 -13.1317 26.5324 40.4931 +7870 4 1.57628 15.538 41.5798 -33.9312 2.46749 -10.4392 +7871 4 2.94928 15.1153 41.6306 46.9044 -35.3027 -23.6199 +7872 6 17.8239 25.728 4.21905 -37.6117 -8.49993 -31.7596 +7873 4 16.8718 25.6243 3.8952 33.4499 1.9374 22.526 +7874 4 18.2969 25.7387 3.3671 7.88894 5.9968 18.5236 +7875 6 41.8048 11.1855 20.2736 -2.74436 -4.31591 -6.39865 +7876 4 42.499 11.3266 19.6063 -2.31748 -7.213 6.47037 +7877 4 40.9812 11.3277 19.7997 -4.16553 7.78699 0.129723 +7878 6 38.0436 18.3822 24.0291 -8.03771 -8.75406 0.916934 +7879 4 38.3881 19.1147 24.5363 7.93091 8.32946 7.65245 +7880 4 37.8775 18.7197 23.1534 1.15748 3.59885 -9.88254 +7881 6 4.13949 13.9245 33.751 32.8429 -54.5446 -5.73928 +7882 4 3.27676 13.674 34.0388 -19.3763 3.63281 4.9893 +7883 4 4.61955 13.0097 33.6871 -20.752 50.0513 -2.76975 +7884 6 19.1955 19.1942 26.4999 -2.68794 -13.6734 16.0889 +7885 4 19.5301 20.0447 26.2113 2.49975 9.05121 -5.4902 +7886 4 18.8802 18.7176 25.7363 0.91839 -0.338605 -10.966 +7887 6 22.4654 26.212 25.3377 -43.9819 -31.3945 15.8492 +7888 4 22.341 25.462 24.7348 6.987 2.92742 -4.90062 +7889 4 23.2684 26.6111 25.1223 47.0594 15.091 -19.0516 +7890 6 48.8212 32.07 32.5598 -32.6217 13.0764 9.49579 +7891 4 48.8519 31.1339 32.3903 9.77015 -16.5586 -2.94571 +7892 4 49.6142 32.4858 32.2593 19.8009 3.1546 -7.06015 +7893 6 25.2092 18.0177 27.0119 4.84672 -18.7822 -3.15467 +7894 4 24.5216 17.4674 27.4199 2.41306 12.0417 3.55819 +7895 4 25.6695 17.4202 26.3966 -2.25094 9.61905 1.21472 +7896 6 1.75029 41.5558 24.9373 10.8929 -9.66126 -16.5331 +7897 4 1.94143 40.8029 24.3062 -11.1729 27.8661 22.017 +7898 4 1.33214 0.330238 24.3814 7.15774 -16.2959 10.6574 +7899 6 18.6827 11.7655 10.8523 -12.8723 -21.6642 16.1997 +7900 4 19.5636 11.9042 10.4948 -5.12175 -0.337419 -4.96303 +7901 4 18.6779 10.8452 11.2231 -2.76434 23.9208 -10.2934 +7902 6 45.6216 16.5622 4.85345 35.2391 7.72621 -8.96994 +7903 4 46.5826 16.2921 4.84248 -29.2944 1.01327 2.32041 +7904 4 45.6571 17.5026 4.56372 -8.00263 -16.2723 6.75488 +7905 6 40.6693 36.3938 24.0175 15.8353 8.34465 -33.37 +7906 4 40.8833 36.7626 23.1096 -14.2319 -6.57786 31.0793 +7907 4 40.765 35.4388 23.9669 -2.25062 -4.28397 3.06966 +7908 6 32.2103 36.323 4.961 11.3673 -15.0032 -27.5021 +7909 4 31.6022 36.0041 4.27996 -13.8963 14.3234 5.17466 +7910 4 32.9864 35.7931 4.73143 4.05858 7.46319 17.1387 +7911 6 1.60869 14.6755 10.8061 -10.0389 6.06769 39.8197 +7912 4 2.33356 15.3221 10.9109 -7.21973 -7.23845 -0.707439 +7913 4 1.19104 14.6475 11.7231 10.7485 2.93157 -30.114 +7914 6 35.0001 14.2727 28.079 63.2852 10.3217 34.449 +7915 4 34.8812 14.1453 29.0533 -4.19424 -2.10072 -23.3494 +7916 4 34.1798 14.2655 27.6589 -51.5469 -5.32036 -14.2309 +7917 6 54.7125 6.11605 21.8555 -14.0361 -8.25377 2.86163 +7918 4 53.7845 6.02557 22.1597 12.8111 1.82594 -4.22103 +7919 4 0.03027 6.89073 22.319 4.64766 10.0402 5.34703 +7920 6 31.7713 16.925 27.3783 -6.86907 -7.88471 17.2493 +7921 4 30.8352 17.1376 27.29 -7.38275 1.84485 -8.02972 +7922 4 32.1916 17.1776 26.567 8.49209 11.7792 -21.4891 +7923 6 14.465 28.0197 11.093 -4.59026 -39.5121 13.6529 +7924 4 14.1257 28.8224 11.4501 -8.46011 24.0779 0.0563038 +7925 4 14.7692 28.1802 10.1981 4.52198 5.50754 -5.24146 +7926 6 35.6475 19.4845 18.3155 9.57103 -1.809 -3.39748 +7927 4 36.1727 19.3545 19.1113 -4.74674 6.51425 2.74698 +7928 4 35.0476 18.7267 18.3208 -0.78661 10.9943 -3.1182 +7929 6 0.909574 12.7326 15.4512 -4.00403 -44.3255 -0.361194 +7930 4 0.713888 11.7498 15.2844 2.79491 38.2978 9.54583 +7931 4 1.42535 12.7402 16.2831 -6.10996 -1.10113 -5.97882 +7932 6 52.7151 14.8297 20.9852 -8.18072 -78.4028 12.8764 +7933 4 52.2089 13.9625 20.7908 19.9141 35.1606 18.4317 +7934 4 52.3599 15.4219 20.3591 -8.09633 28.1752 -16.3986 +7935 6 7.5074 6.79303 13.6094 20.1749 -33.1825 -2.20484 +7936 4 7.51894 7.72815 13.8132 13.5555 7.5777 -3.02343 +7937 4 8.44355 6.42469 13.5879 -32.5694 21.0012 0.325521 +7938 6 12.8707 29.146 30.9458 -23.5578 15.3335 -40.981 +7939 4 12.9428 28.445 30.3111 -4.06483 -0.044806 -18.3112 +7940 4 13.2276 28.7127 31.6654 25.7046 -17.9249 62.7325 +7941 6 8.91318 29.991 35.6703 -0.0610651 3.14803 31.5119 +7942 4 8.887 30.0597 36.6571 13.1627 -14.4278 -23.4692 +7943 4 8.81345 30.9051 35.4106 0.983205 7.41015 -17.1111 +7944 6 29.2436 7.20633 5.57892 -54.0378 33.243 -15.4453 +7945 4 29.9077 6.6209 5.82325 37.3203 -38.0996 12.3519 +7946 4 28.4255 6.92245 6.05186 24.5111 10.6259 -6.90283 +7947 6 25.8948 9.2579 3.86177 -16.7921 -19.1399 -16.9328 +7948 4 26.6486 8.78935 3.46547 3.6066 2.83982 9.7025 +7949 4 25.146 8.75694 3.47524 9.6908 8.1243 10.3781 +7950 6 46.1591 19.5353 23.8511 81.1089 -3.44953 5.31324 +7951 4 47.0572 19.4192 24.3423 -46.5837 0.334518 -9.80273 +7952 4 46.5432 19.8542 23.0066 -21.4105 0.836057 1.37554 +7953 6 18.5926 35.3225 28.784 52.2521 -24.0621 1.05868 +7954 4 18.6271 36.1437 28.292 -9.91963 10.3291 -8.20284 +7955 4 19.5499 34.9756 28.7398 -42.866 14.0686 4.10052 +7956 6 27.9863 22.6413 32.202 21.6529 -11.7193 -18.2399 +7957 4 28.0891 22.9783 31.3009 1.03266 3.02954 6.56078 +7958 4 27.1414 22.9613 32.5068 -4.28354 -0.549074 4.96673 +7959 6 25.9903 18.4326 22.6797 -22.9747 -15.6034 11.3844 +7960 4 26.7869 18.8273 22.3692 24.9379 13.7229 -5.91644 +7961 4 25.7208 18.921 23.4832 11.724 -6.94511 -8.75168 +7962 6 31.1697 23.092 29.1693 -11.9745 -15.1316 21.2053 +7963 4 31.2077 22.141 28.9533 -3.34012 7.58841 -3.35467 +7964 4 31.7416 23.575 28.5808 9.8436 3.86516 -11.5721 +7965 6 36.6303 4.93142 0.48008 48.3 12.3871 -22.3067 +7966 4 36.6637 5.82298 0.895967 -3.77214 -15.5899 -6.86281 +7967 4 37.4556 4.91994 41.7793 -42.6939 0.501904 23.801 +7968 6 36.4828 20.995 10.0445 1.4409 16.9025 7.88029 +7969 4 36.442 20.1354 9.60774 -3.67605 2.90774 1.0232 +7970 4 35.8889 20.9899 10.8082 0.675338 -5.55749 -3.21659 +7971 6 50.6068 25.1826 18.3885 -34.0155 8.99756 4.28297 +7972 4 49.9165 24.7513 17.8483 3.12051 4.84127 10.9758 +7973 4 51.4426 24.9479 18.0312 23.0155 -7.64449 -5.94589 +7974 6 50.1857 39.6546 12.4249 -35.8487 -4.75972 18.1961 +7975 4 49.7435 38.8097 12.6589 9.38526 12.3917 -5.89531 +7976 4 51.0761 39.4561 12.2056 25.3285 -5.23538 -8.69122 +7977 6 30.5392 12.4112 4.81308 -24.6918 -8.37115 23.8709 +7978 4 30.0105 11.5821 4.90198 12.5687 16.0288 7.14 +7979 4 30.9611 12.2897 3.99028 20.9425 -4.88336 -30.4106 +7980 6 28.9507 15.4785 21.8764 2.88494 -37.77 16.9414 +7981 4 29.2026 14.5932 22.3105 -13.0637 39.016 -13.1967 +7982 4 28.2142 15.8194 22.4189 7.40001 -5.36107 -10.8423 +7983 6 14.0621 9.56364 16.9937 6.86557 -12.9325 3.68967 +7984 4 14.7638 8.91135 17.1437 -0.397896 3.39204 -3.97785 +7985 4 14.5001 10.412 17.0773 -1.84745 7.98018 -3.95086 +7986 6 4.48418 30.1793 11.8502 16.4679 -16.8356 33.0547 +7987 4 4.88144 29.8061 12.6848 -7.18701 8.62616 -23.9784 +7988 4 3.54784 30.2411 12.0492 -7.30801 4.11375 -9.31782 +7989 6 40.8925 8.06286 23.6531 -5.33465 -0.617655 -7.49645 +7990 4 40.8929 8.28602 22.6923 5.67883 -10.477 13.1878 +7991 4 40.7177 7.10184 23.7416 4.86142 9.55736 -10.8624 +7992 6 53.7474 35.0502 16.7091 9.64852 13.8526 -34.5004 +7993 4 53.4511 35.8404 17.1588 -1.68768 2.98716 11.3576 +7994 4 54.0332 35.3898 15.821 -5.01984 -16.258 24.672 +7995 6 53.7089 10.1864 20.3635 2.29909 -3.91508 11.8946 +7996 4 53.865 9.95358 19.435 -6.30341 10.2468 0.803923 +7997 4 53.074 10.9174 20.4153 4.1525 1.61451 -13.3956 +7998 6 4.58325 27.0727 7.79253 38.2121 26.3993 -10.0836 +7999 4 5.27724 26.393 7.80253 -10.2172 -9.80276 1.23658 +8000 4 3.71677 26.7514 7.92113 -24.69 -25.9094 6.50141 +8001 6 50.5074 22.5408 22.1421 -8.69376 -16.3879 19.9073 +8002 4 50.2488 23.2402 22.7623 5.11604 2.17524 -13.9015 +8003 4 50.7961 22.8564 21.2903 3.5618 14.8025 -7.32432 +8004 6 7.04732 27.2027 21.6256 -40.8926 -21.8944 23.9514 +8005 4 6.7035 26.7027 22.422 28.3929 12.8045 -18.4773 +8006 4 6.19014 27.4064 21.2095 22.0893 5.82121 -6.88916 +8007 6 23.8331 35.0488 16.5891 16.32 14.4309 46.4508 +8008 4 24.6955 34.7392 16.9507 -15.4311 10.68 -10.0146 +8009 4 23.6772 34.608 15.7848 -0.180345 -20.5093 -35.2233 +8010 6 5.99568 23.9111 3.91414 -16.1284 -13.3557 2.33299 +8011 4 5.47632 24.0272 3.08057 3.14343 -7.41418 20.837 +8012 4 5.41258 23.5631 4.6401 5.53308 9.77645 -18.8553 +8013 6 38.7285 25.0725 19.1284 6.5843 12.292 11.4002 +8014 4 38.8305 24.3279 18.5317 -0.433768 -14.0645 -4.65001 +8015 4 38.9527 24.8378 20.0476 4.74577 -1.1864 -10.184 +8016 6 12.9754 18.2903 10.6176 0.588158 -4.74371 -11.7219 +8017 4 12.1189 18.2831 10.1754 -4.50324 1.27903 -1.36841 +8018 4 12.8026 18.5801 11.5112 2.24696 5.46905 14.7352 +8019 6 38.0467 41.2366 21.1082 -14.4892 -16.6352 -5.66336 +8020 4 37.1721 40.8226 21.1941 10.2151 -2.13153 3.70269 +8021 4 37.8745 0.133442 20.6393 0.730193 23.6843 -6.95691 +8022 6 6.9767 22.8602 17.8447 -15.6268 -18.8158 0.81989 +8023 4 7.5707 23.5707 17.6602 21.732 18.7089 -7.75629 +8024 4 7.31556 22.0497 17.428 2.05587 4.83625 4.35773 +8025 6 24.1095 19.3932 12.3316 12.1602 -2.11517 -13.1018 +8026 4 23.8745 19.734 13.1953 2.64822 12.0925 0.881714 +8027 4 23.8476 18.4865 12.3899 -10.6841 -23.2361 -5.46211 +8028 6 44.2232 28.4408 4.82746 -1.7669 2.66578 -25.5607 +8029 4 44.2803 28.1144 3.91045 1.22274 -3.80694 10.7546 +8030 4 44.1446 29.3994 4.68927 4.81937 -0.158515 8.55 +8031 6 23.3113 8.29915 21.4219 -9.51684 27.1403 7.66167 +8032 4 22.936 9.22921 21.4746 15.7805 -27.4461 5.90598 +8033 4 23.1012 8.0569 20.5135 3.89809 -6.65443 -0.402871 +8034 6 14.3464 2.18773 18.5362 -23.516 16.4481 4.67993 +8035 4 14.2678 1.24418 18.6898 10.1474 -10.2606 4.48578 +8036 4 15.2445 2.40605 18.3047 18.9771 -8.71598 -6.68368 +8037 6 28.0424 31.9381 34.1184 1.44373 -10.4149 10.0158 +8038 4 28.467 32.321 34.8914 3.92062 5.65333 3.09761 +8039 4 27.2701 32.5111 33.9835 5.51879 -6.95928 -12.9635 +8040 6 53.345 24.6925 18.2818 -10.4918 -25.9433 -31.7967 +8041 4 53.4866 24.6975 17.3285 -0.882305 -10.6531 -2.1422 +8042 4 53.7306 25.5021 18.5264 15.118 39.739 24.3772 +8043 6 36.8049 28.4285 22.9464 16.1639 5.31016 -1.79263 +8044 4 36.683 28.9472 23.7552 -13.3671 -7.69746 -0.238436 +8045 4 36.1639 27.7179 22.9267 -11.0056 -9.60672 10.1241 +8046 6 21.894 30.586 27.4834 -30.837 -7.47848 12.2714 +8047 4 22.1658 31.0121 28.3029 9.93408 7.2142 -4.82479 +8048 4 22.5499 30.6966 26.8178 23.3081 1.01511 -13.2982 +8049 6 10.2866 3.2829 27.2371 9.19947 -3.548 -7.92128 +8050 4 10.1566 2.73648 28.0281 -11.5907 7.20828 -5.58516 +8051 4 9.50383 3.79492 26.9844 -8.05462 -4.00143 11.7964 +8052 6 37.7145 25.01 29.7057 15.6828 -51.4836 -24.4954 +8053 4 38.34 24.5625 29.0621 -16.831 21.3675 19.2093 +8054 4 37.2613 24.2159 30.07 -2.41186 22.6264 5.87672 +8055 6 9.13271 24.4444 14.4751 26.0421 8.18538 46.692 +8056 4 9.10912 24.9781 13.7161 -5.31341 21.9098 -32.4591 +8057 4 8.68548 23.6494 14.2981 -19.3974 -37.2941 -14.6224 +8058 6 52.771 31.4727 7.38558 20.6973 -2.13415 1.08713 +8059 4 52.3061 32.183 6.93204 -2.34942 2.78723 -4.55897 +8060 4 52.1263 30.9997 7.89938 -16.8139 -9.70652 3.3966 +8061 6 21.3286 5.45224 36.4983 22.333 -40.4406 3.83692 +8062 4 20.7026 5.40277 37.2139 -7.55906 11.9598 8.05023 +8063 4 21.8475 4.61683 36.6516 -9.65069 29.8227 -15.0031 +8064 6 25.1743 37.2092 4.31919 7.23092 6.80805 -6.24923 +8065 4 25.4754 36.7175 3.5165 -8.68629 0.834167 19.7743 +8066 4 24.8491 36.6197 5.01948 2.53349 -5.19005 -7.77823 +8067 6 34.0165 17.4759 18.2358 -58.4306 -31.0723 45.6386 +8068 4 34.1944 16.9598 19.0779 8.50138 15.1756 -22.5601 +8069 4 33.0528 17.7413 18.4058 39.5305 3.9888 -12.396 +8070 6 37.9578 37.5059 25.2944 -35.6234 -15.4362 -10.7836 +8071 4 36.9622 37.6721 25.197 38.0574 -5.35834 -1.14338 +8072 4 38.1643 36.7565 24.689 -7.79603 13.8086 8.25116 +8073 6 5.07735 4.86484 15.8417 42.9381 3.72816 7.10952 +8074 4 5.88838 4.293 15.9163 -33.8081 0.492332 -6.16483 +8075 4 5.50277 5.71956 15.9997 -16.006 -0.473971 1.61617 +8076 6 14.1507 7.19336 7.76886 38.052 -10.4208 -22.4486 +8077 4 13.5129 7.55624 8.34295 -29.9694 15.266 25.1048 +8078 4 13.7195 6.96448 6.9333 -0.98027 3.69224 9.82406 +8079 6 24.98 10.8641 38.0829 22.9212 14.7137 56.6455 +8080 4 25.3157 11.7906 38.09 -5.76353 -21.6486 -14.5596 +8081 4 24.5861 10.6473 37.2742 -21.4949 -6.61803 -48.2716 +8082 6 35.683 7.97762 22.8121 -8.7657 -2.24292 -6.28447 +8083 4 36.2591 8.71308 23.0369 7.49089 3.45465 4.10549 +8084 4 35.4159 8.13228 21.894 -1.16553 2.61323 2.89561 +8085 6 24.8067 29.1485 22.4175 -2.13284 -11.1741 5.39142 +8086 4 24.8847 28.3567 22.9764 5.78872 7.02228 0.265808 +8087 4 23.868 29.1687 22.2304 -8.38579 3.51829 -7.32943 +8088 6 38.496 31.6463 38.4547 5.18571 -7.52333 -11.192 +8089 4 38.5561 32.3892 37.8222 0.442926 -5.96945 11.3455 +8090 4 38.4779 31.9675 39.3579 -6.04594 15.0172 8.52038 +8091 6 7.23911 33.2316 15.4021 21.919 9.41665 12.382 +8092 4 8.12833 33.2899 15.8377 -30.0201 5.59214 -9.80336 +8093 4 7.41373 32.5516 14.7298 -12.8129 5.82399 11.4308 +8094 6 43.353 23.6104 1.44592 7.44142 11.305 12.851 +8095 4 43.1845 24.4377 0.974361 -3.6145 -11.1369 -5.61195 +8096 4 44.1543 23.8467 1.95013 -11.1925 -12.9992 -13.6036 +8097 6 3.53991 32.9016 14.8697 -2.39625 2.76445 6.29056 +8098 4 3.69073 33.2429 13.9877 -3.53656 0.018747 -12.9915 +8099 4 3.78624 33.6349 15.4383 2.83762 5.11564 5.16825 +8100 6 25.3096 21.77 8.26163 -6.66296 0.990367 -4.9072 +8101 4 26.025 21.1206 8.24337 -4.14835 5.1806 10.2199 +8102 4 24.7855 21.68 9.08833 13.2195 -2.77387 -11.0894 +8103 6 43.8224 15.3683 17.7688 -17.5044 -13.9077 -11.4765 +8104 4 43.5422 15.0425 16.8907 -4.65964 7.2866 4.53357 +8105 4 44.7684 15.2434 17.7192 12.2011 1.97977 1.51727 +8106 6 15.7838 16.2525 16.6573 54.0838 12.7989 52.3812 +8107 4 16.4697 16.8261 16.2793 -6.54184 -0.771336 -3.5329 +8108 4 15.1467 16.1661 16.0105 -48.6612 -2.23154 -48.9531 +8109 6 31.9022 12.8519 11.5241 2.75902 49.2592 5.12049 +8110 4 32.4395 13.2725 12.2474 -7.6131 -20.2803 -12.0836 +8111 4 31.5562 13.6461 11.0457 0.0384164 -26.7823 6.27126 +8112 6 18.2248 5.33623 10.1812 -15.488 18.8418 -23.6702 +8113 4 17.7687 5.75894 9.42369 15.7694 -11.8332 4.62439 +8114 4 17.5271 5.29555 10.8288 -1.36455 -9.23689 12.3446 +8115 6 23.0917 39.0779 10.9282 -11.4905 7.21092 -0.352408 +8116 4 23.963 38.6888 10.8472 1.7552 7.95734 1.65941 +8117 4 23.1114 39.9529 10.5005 0.666922 -10.0515 1.633 +8118 6 46.8677 33.7562 8.76248 1.03354 -2.05441 8.38343 +8119 4 46.5037 34.5328 8.27588 2.5022 -8.853 20.9954 +8120 4 47.1475 33.9422 9.6931 -6.44786 13.1686 -22.3696 +8121 6 31.243 39.9317 20.2224 2.33635 -7.70313 -8.05101 +8122 4 30.8704 39.2996 19.5871 0.699046 7.37293 6.91414 +8123 4 32.2017 39.8574 20.0757 -3.27099 6.09826 0.0696837 +8124 6 15.889 33.0919 19.7864 33.8788 -7.40125 -13.3883 +8125 4 16.1628 33.8221 19.1895 -10.4151 -15.5823 0.760964 +8126 4 16.5176 32.3427 19.5839 -16.9866 18.4919 10.6578 +8127 6 32.5555 39.9164 2.66523 30.0039 -10.6491 -2.95451 +8128 4 33.3508 39.5896 3.12591 -10.8726 3.49711 -8.16538 +8129 4 32.1027 40.3655 3.36837 -16.5932 8.39248 6.84073 +8130 6 50.6959 12.1983 3.90519 17.0412 -18.9771 -24.2847 +8131 4 51.4658 12.4814 3.40053 -2.43524 -2.94964 -4.56419 +8132 4 50.632 12.8314 4.58319 -9.04718 30.5099 32.8795 +8133 6 44.7022 2.76366 12.1205 -8.84849 12.6495 8.41904 +8134 4 44.8494 1.8734 11.8267 15.0216 -15.1797 -4.64519 +8135 4 44.7278 2.73137 13.1008 3.87902 2.35132 -20.2006 +8136 6 11.5141 11.9335 31.6448 -3.41939 3.48047 19.9552 +8137 4 11.2577 12.7405 32.1375 2.53248 -5.05318 0.0588515 +8138 4 11.4496 11.2091 32.2982 6.40928 8.91696 -7.15415 +8139 6 4.75269 10.0418 10.4949 -1.19321 15.9867 3.21309 +8140 4 5.0001 10.2283 11.4058 3.15466 -0.54389 -0.234941 +8141 4 4.46559 10.9018 10.1184 3.18705 -14.0527 1.96128 +8142 6 17.0994 25.0099 20.58 37.5195 36.994 -31.4742 +8143 4 16.2483 24.8536 20.9144 -42.3557 -15.7488 8.6923 +8144 4 16.9647 25.6792 19.8535 4.26961 -24.361 15.5384 +8145 6 48.1092 4.75471 14.8037 19.9531 12.9172 -19.4869 +8146 4 47.21 5.0173 14.8371 -33.3483 -4.43172 15.4156 +8147 4 48.388 5.38041 14.11 12.4129 -13.382 8.75366 +8148 6 18.8523 3.11742 3.41631 -21.2483 -3.07087 -4.7476 +8149 4 18.4665 2.24821 3.59937 1.50537 0.955968 2.27262 +8150 4 19.7704 2.98892 3.60058 26.8928 -3.50499 2.30699 +8151 6 35.4247 26.4577 29.0527 -22.8013 -8.66021 5.68805 +8152 4 35.5248 27.2067 28.475 -2.85698 13.778 -9.76065 +8153 4 36.2768 26.0489 29.0602 21.3259 -10.4415 3.203 +8154 6 32.3896 31.2185 12.8503 57.1958 12.7231 -6.23232 +8155 4 31.5925 31.2509 13.3022 -48.7441 2.01486 27.8379 +8156 4 32.2029 30.8426 12.0127 -5.8383 -14.614 -31.3947 +8157 6 33.0076 28.3366 37.5983 -27.3824 -5.67666 30.0102 +8158 4 32.1052 27.9852 37.8568 28.4022 2.55731 -9.07316 +8159 4 33.3988 28.5694 38.4733 -3.969 -4.9759 -22.0899 +8160 6 45.5072 24.7908 10.3169 -45.8214 60.3209 -7.47747 +8161 4 44.9002 25.317 9.70444 28.5781 -13.9385 29.3176 +8162 4 45.5876 23.9971 9.85482 14.9117 -49.3191 -19.3714 +8163 6 14.779 31.7044 3.16918 -45.5594 -6.97168 29.5477 +8164 4 14.0337 32.2859 2.90387 21.9125 -3.3602 -3.07131 +8165 4 14.4311 31.26 3.996 20.2164 14.1486 -26.6391 +8166 6 31.9242 7.68885 4.30286 23.54 -20.9123 31.4536 +8167 4 31.4705 6.84633 4.17995 2.0164 -2.82895 4.59018 +8168 4 31.5931 8.24323 3.64247 -18.259 33.7262 -37.7068 +8169 6 42.5699 17.3136 32.1968 24.1944 7.3606 3.32713 +8170 4 41.6254 17.2329 32.2603 -19.9776 4.79877 -7.53323 +8171 4 42.7917 18.2007 31.8224 -10.4585 -19.5065 0.0265862 +8172 6 13.8071 23.1746 23.5515 16.4347 -15.6283 -2.15259 +8173 4 13.5183 23.7639 24.245 0.233797 9.11225 10.6616 +8174 4 14.6093 22.7029 23.9066 -20.7684 16.5326 -5.05411 +8175 6 10.7126 7.09833 3.97095 14.1471 -33.6721 -68.9477 +8176 4 10.4245 6.93934 4.82914 -14.4566 -0.97954 55.1879 +8177 4 10.4869 6.2311 3.50145 10.3151 35.4271 10.8748 +8178 6 28.7967 8.6797 17.9015 -30.1103 -2.72244 -33.0478 +8179 4 29.5795 8.35746 17.4579 9.90558 -6.78874 -8.85398 +8180 4 28.1705 8.90161 17.1378 19.1156 -3.64084 26.8114 +8181 6 19.4515 29.3423 26.6295 -39.4767 12.5835 42.7579 +8182 4 19.0038 29.6555 27.482 17.5864 -10.0531 -35.2193 +8183 4 20.2946 29.7741 26.6551 17.8114 4.03003 1.9258 +8184 6 40.6571 40.9865 14.5722 30.7749 0.116883 17.4953 +8185 4 40.9453 41.7159 14.038 -4.90719 13.3855 -18.4876 +8186 4 41.4974 40.7167 14.9881 -11.2006 -4.47055 2.16552 +8187 6 46.2595 14.0857 31.7293 11.6035 -9.35965 4.24636 +8188 4 46.4659 13.1386 31.6985 -1.25294 5.8657 1.71226 +8189 4 45.5092 14.1916 31.1613 -13.5258 4.10617 -10.238 +8190 6 36.7111 36.3198 8.38634 20.5175 24.5507 44.7988 +8191 4 36.5848 37.248 8.66174 -25.6048 -20.3538 -28.8485 +8192 4 37.4262 36.1922 9.03978 -4.76011 -28.7723 -18.9481 +8193 6 30.7791 32.4382 38.0814 8.60258 1.74334 21.9396 +8194 4 31.3949 31.9394 37.5795 9.21482 -20.9838 -26.5205 +8195 4 31.4122 32.9586 38.5821 -11.3785 16.1645 3.6603 +8196 6 47.8794 8.8384 10.1746 26.299 41.1069 27.7005 +8197 4 47.2075 9.11907 9.56312 -13.0744 -2.84885 -16.672 +8198 4 48.1152 7.93695 10.1106 -1.40956 -33.8723 -12.987 +8199 6 24.4191 17.0005 30.9872 -11.3759 2.04439 -13.9008 +8200 4 23.6647 16.9339 30.3566 16.9629 0.0568796 9.7226 +8201 4 24.0218 17.1528 31.8579 2.94571 -1.21426 -7.57694 +8202 6 40.5018 5.09847 4.47991 -26.6992 -20.3188 -5.14046 +8203 4 41.28 5.65048 4.47318 14.3705 11.228 -11.5737 +8204 4 40.0798 5.05838 3.58104 19.0568 4.03597 15.916 +8205 6 52.5742 28.0973 6.9077 -25.4379 -29.0344 16.6943 +8206 4 52.3933 28.6001 6.11132 1.2128 1.19853 -1.81518 +8207 4 51.7383 27.5823 7.10916 28.4347 22.908 -9.38917 +8208 6 36.064 32.3866 23.6124 7.53581 -25.1682 -6.10704 +8209 4 36.4508 32.2046 22.7426 1.48893 5.77393 9.47334 +8210 4 35.7934 33.2936 23.5958 -9.41601 17.7382 0.925908 +8211 6 23.6488 31.8764 22.7665 2.85736 4.06253 -9.33391 +8212 4 23.7634 32.5358 22.0878 -9.04528 15.3932 -0.43099 +8213 4 24.3599 31.3007 22.5126 8.23075 -21.5035 13.0322 +8214 6 0.735457 24.4657 41.7131 -9.37188 -1.3071 -20.2528 +8215 4 1.20497 24.8068 40.9273 -3.735 -3.01915 11.177 +8216 4 54.8235 24.2347 41.4089 15.688 5.53844 3.35783 +8217 6 15.9771 8.98022 19.8191 22.6241 -28.8974 20.594 +8218 4 15.5109 8.26292 19.4118 -7.13343 -10.7615 -13.7959 +8219 4 15.6388 9.77471 19.4696 -19.2292 39.8019 -15.8774 +8220 6 33.1716 12.5629 20.0326 13.9441 -12.6476 -4.49459 +8221 4 32.9044 11.6183 19.8429 16.5289 30.3248 6.35834 +8222 4 34.162 12.7185 19.975 -34.5589 -12.2038 -12.3621 +8223 6 7.03971 24.945 26.3683 -0.33354 -9.69316 23.9049 +8224 4 6.80945 24.3756 27.1101 -9.22275 -9.46444 -2.85995 +8225 4 7.84656 25.3251 26.6963 17.391 9.90995 -3.06061 +8226 6 44.4739 22.5508 36.9255 -16.7075 -6.88118 10.4755 +8227 4 43.5027 22.4108 36.9334 15.1456 1.07948 9.67769 +8228 4 44.6732 22.7799 36.0336 3.04889 5.98288 -21.3947 +8229 6 39.2775 23.7142 25.1185 -44.4168 -97.0378 5.9092 +8230 4 39.6033 24.5307 24.937 33.9242 88.3913 -14.6991 +8231 4 38.7559 23.4597 24.3323 8.03463 3.9453 13.1815 +8232 6 20.3756 2.20712 36.9897 -7.56257 -5.27652 1.95266 +8233 4 20.2168 1.45659 37.5665 4.06747 -3.41627 8.94019 +8234 4 20.2802 1.85339 36.1124 5.28277 1.38 -10.8685 +8235 6 22.8571 19.5527 3.6659 6.2145 7.79245 45.4341 +8236 4 22.8782 19.7834 4.64919 -10.5004 -5.13291 -37.3231 +8237 4 23.7426 19.8021 3.38476 9.02488 -3.84737 -6.15569 +8238 6 31.6989 12.5719 34.5929 20.3571 12.3337 69.8717 +8239 4 31.0774 13.2339 35.0297 17.9304 -15.3013 -22.977 +8240 4 32.3378 12.3324 35.3667 -30.4994 7.85147 -45.3393 +8241 6 12.9846 10.2214 25.1019 -30.6317 10.0697 -32.3453 +8242 4 13.6677 9.95937 25.6652 38.8731 -4.05338 37.0168 +8243 4 12.5116 9.4018 25.0264 -11.673 -9.01961 -8.06086 +8244 6 27.2702 0.587979 13.2088 -29.2359 -8.68669 8.17042 +8245 4 27.7024 41.6312 13.2942 -2.56798 3.03598 -7.56301 +8246 4 26.2795 0.464606 13.259 26.6373 -0.778522 -5.81594 +8247 6 5.6575 24.9337 13.9905 13.1991 2.90197 -9.87868 +8248 4 4.70598 24.9553 13.883 -5.9976 0.782062 8.57209 +8249 4 5.90972 25.4072 14.7914 -9.20077 -1.59682 1.38283 +8250 6 22.9799 17.9518 0.527007 -12.0607 -30.0717 13.8125 +8251 4 22.428 18.6392 0.176667 -3.67819 14.6501 -9.17369 +8252 4 22.2816 17.3415 0.914453 31.709 16.1034 -10.9012 +8253 6 33.0985 25.4181 5.46205 -15.7978 -31.0624 1.20161 +8254 4 33.3789 26.3039 5.55078 15.9502 30.9866 -6.27287 +8255 4 32.9645 25.2082 4.52957 3.04969 3.7853 3.27689 +8256 6 8.52872 7.94688 17.4833 18.4257 15.9711 -24.7978 +8257 4 9.39098 8.3855 17.3119 -11.8135 -8.35054 -2.98105 +8258 4 8.4858 7.94817 18.4262 -6.55829 -2.0729 23.5191 +8259 6 26.8237 0.686378 2.88748 4.07 30.2002 2.01549 +8260 4 26.8412 0.391628 3.80568 -3.86709 0.733005 8.35451 +8261 4 26.5975 1.66265 2.91719 8.86873 -29.5911 -1.41132 +8262 6 50.0397 34.7157 15.6267 -11.8175 -1.09292 -1.87233 +8263 4 50.6372 35.2521 15.0721 -14.1207 -5.91477 -4.02646 +8264 4 49.1323 34.6374 15.219 24.748 6.82197 2.94942 +8265 6 46.275 5.00035 11.1282 9.7079 18.7279 -10.06 +8266 4 45.8191 4.20733 11.3912 -11.1099 -14.8598 8.88229 +8267 4 46.9633 4.71614 10.5231 1.70636 -6.51939 -1.67277 +8268 6 33.7833 38.63 35.3851 22.6491 -26.5736 53.3982 +8269 4 34.0604 38.9625 36.3013 -14.2885 -2.00103 -44.5517 +8270 4 33.6201 39.3455 34.786 -2.63152 22.0909 -4.2817 +8271 6 30.8201 25.8435 41.2101 0.522631 -30.718 -12.9218 +8272 4 31.0968 24.9266 41.4082 -1.05643 6.85883 -6.1679 +8273 4 31.1715 26.3436 0.016995 6.66556 20.3816 22.2796 +8274 6 50.2276 0.978128 24.4598 74.6558 22.0158 36.8282 +8275 4 49.5306 0.534407 24.0585 -38.5843 -30.8873 -31.929 +8276 4 51.1134 0.532188 24.3239 -37.6779 9.32343 -0.630533 +8277 6 31.2996 0.720873 19.0302 14.3507 40.5737 -10.6901 +8278 4 30.4605 0.743437 18.5837 -16.9464 -9.10756 -3.3833 +8279 4 31.3343 41.8987 19.5933 -6.31648 -47.867 22.0648 +8280 6 39.0778 29.5479 19.1423 -24.9794 -6.4558 -1.7207 +8281 4 38.1293 29.5816 19.4551 33.1986 -8.08964 -3.40762 +8282 4 39.446 28.6506 19.2986 -6.02354 14.8003 0.990496 +8283 6 21.659 17.5991 25.8953 -11.5386 33.2832 -7.33353 +8284 4 22.0418 18.5204 25.967 -8.02723 -30.5851 6.12101 +8285 4 20.778 17.7492 25.4824 18.7799 -9.30112 4.66445 +8286 6 35.0777 28.803 27.4254 -1.70316 -21.0069 37.4458 +8287 4 35.3301 29.4791 28.0775 3.3924 -2.39002 -8.5847 +8288 4 35.0935 29.2141 26.5843 6.79083 21.8236 -32.9604 +8289 6 30.7137 25.4449 11.6588 -11.4017 25.922 39.321 +8290 4 30.5753 25.9017 12.5616 8.60864 -26.5127 -36.0552 +8291 4 30.5331 26.1452 11.022 4.69716 -0.666916 0.479504 +8292 6 7.33812 15.1344 12.3538 4.68116 -40.544 31.6975 +8293 4 6.75693 14.3594 12.209 2.06777 16.361 -3.14284 +8294 4 7.31295 15.622 11.5607 -9.0052 27.071 -31.8075 +8295 6 16.8334 26.8188 7.04972 -25.5936 3.66279 -30.8653 +8296 4 17.5758 26.708 7.59816 38.4339 -11.2263 23.8467 +8297 4 17.1819 26.9966 6.1597 -5.58153 -2.73835 6.66814 +8298 6 29.5302 33.0784 31.0001 -37.3865 -15.0005 -19.6245 +8299 4 28.6433 32.7554 30.7459 2.04647 15.9344 -4.27919 +8300 4 29.8764 32.2746 31.3613 18.5632 -10.7791 20.7082 +8301 6 14.1048 2.11879 30.9099 -3.69766 -14.7615 43.6071 +8302 4 14.1458 1.95878 31.9138 -8.46722 9.63961 -39.7078 +8303 4 13.6642 1.31591 30.5661 9.09938 8.95306 -0.112961 +8304 6 15.6571 22.2632 2.89617 -37.5764 43.5932 -9.62192 +8305 4 16.4348 21.7941 3.05118 39.5293 -34.0009 4.7875 +8306 4 15.0286 21.6897 2.4522 -3.10464 -12.538 6.06705 +8307 6 23.7259 29.1153 40.9645 17.3396 38.8389 1.6287 +8308 4 23.2818 30.0193 40.9831 11.4767 -32.1544 -0.906545 +8309 4 24.7087 29.2887 40.9216 -25.4222 -7.32646 2.20707 +8310 6 38.1247 14.1642 13.7107 12.8592 31.0763 6.54808 +8311 4 37.6278 13.3808 13.8383 -17.8092 -31.0521 2.1891 +8312 4 38.9029 13.9224 13.2095 7.41852 -3.42228 -8.90759 +8313 6 35.2503 26.5068 15.521 -3.09354 13.3371 19.8917 +8314 4 34.5349 26.5126 14.8818 -0.932758 -4.81772 -4.34805 +8315 4 34.9075 27.0382 16.2823 10.0491 -13.0104 -19.4153 +8316 6 19.0968 34.7379 16.486 5.71756 23.995 22.7437 +8317 4 19.4075 35.6523 16.3704 4.72819 -11.1284 17.3551 +8318 4 19.0401 34.4508 15.6072 -6.41662 -20.6903 -39.0731 +8319 6 18.1723 29.7514 35.7083 20.6671 12.6318 -10.71 +8320 4 18.3041 30.5743 35.1773 -7.60682 -14.8418 20.474 +8321 4 19.0351 29.5718 36.145 -10.3356 2.9076 -6.19235 +8322 6 54.1213 22.2675 24.9131 12.7342 -33.1199 -26.8219 +8323 4 53.6265 21.7967 24.1967 9.15099 10.4438 12.7736 +8324 4 53.5183 22.8995 25.2476 -23.1208 24.5105 7.38222 +8325 6 30.3446 10.3415 34.0026 7.84994 -0.761596 -9.91104 +8326 4 29.5868 10.4349 34.5739 -14.9697 1.07498 11.7851 +8327 4 30.8511 11.1643 34.0933 -4.52293 -3.62201 3.70872 +8328 6 38.3178 33.8965 18.5989 -35.8058 -11.4104 -3.76591 +8329 4 38.923 33.166 18.7063 19.7544 -4.29321 9.06839 +8330 4 38.8137 34.6503 18.3352 23.7539 21.4454 3.52643 +8331 6 22.4873 14.1653 34.4312 -21.9658 -17.0918 -49.1801 +8332 4 22.5571 13.4626 33.7145 -4.81718 29.7264 22.473 +8333 4 23.0772 13.8965 35.1058 26.7449 -1.29975 22.8703 +8334 6 38.021 0.617904 2.36461 -2.26574 -7.91048 -40.4777 +8335 4 37.6239 1.19646 3.0125 3.99393 1.59858 23.4614 +8336 4 38.7851 0.132723 2.71367 -6.22024 4.30596 13.4956 +8337 6 38.885 41.133 10.292 38.4397 69.693 -20.9517 +8338 4 38.7327 0.223589 10.3334 0.502898 -40.1285 -2.38265 +8339 4 38.1678 40.7662 10.7395 -40.074 -22.1176 34.0334 +8340 6 53.417 21.9266 38.962 18.4876 1.53578 17.2983 +8341 4 52.9974 21.8755 38.1026 3.71535 5.74942 -10.4205 +8342 4 54.37 22.1639 38.7939 -25.8904 -11.793 -3.59034 +8343 6 39.9933 12.7125 36.2959 -18.8272 27.1562 12.2819 +8344 4 39.0734 12.4542 36.2547 -7.90274 -1.75871 9.35878 +8345 4 40.3901 12.0873 35.7283 26.8007 -18.4843 -23.2317 +8346 6 48.44 17.2431 40.5981 -19.9836 6.93831 4.04917 +8347 4 47.6199 17.7956 40.4399 22.5854 -23.5642 7.97707 +8348 4 48.3147 16.8142 41.4747 5.07747 10.2388 -9.33604 +8349 6 32.0284 9.3439 40.0151 10.5149 -12.1651 13.6504 +8350 4 32.8546 9.41316 39.523 -1.99935 -3.17675 -6.39298 +8351 4 31.9706 8.39334 40.2816 -10.0936 21.7982 -4.27543 +8352 6 31.75 22.4929 6.3685 -34.2181 3.54143 23.53 +8353 4 31.3779 21.709 6.82557 12.2201 6.35834 -11.7559 +8354 4 31.3059 23.2194 6.8777 16.0591 -13.7554 -15.3432 +8355 6 51.0144 2.58529 21.579 28.4772 -3.64411 10.4611 +8356 4 51.4343 1.72703 21.8198 -11.0001 9.38403 -4.71992 +8357 4 51.7571 3.20177 21.4507 -11.3685 -6.83795 2.38662 +8358 6 13.6247 22.0465 12.1442 29.0901 0.46256 9.76546 +8359 4 14.4578 22.3795 12.5465 -13.9989 1.27328 -8.95219 +8360 4 12.915 22.6494 12.3833 -3.04453 8.5056 -1.94564 +8361 6 23.6209 24.0381 14.6453 -17.5202 11.834 -36.5316 +8362 4 24.2009 24.4886 15.2598 9.8869 4.60732 -3.70937 +8363 4 23.5497 24.6116 13.8304 3.00595 -20.2815 30.972 +8364 6 9.32136 4.85156 31.2387 8.97842 0.466865 -3.67014 +8365 4 8.41764 4.8259 30.9291 -8.7496 -0.132795 -7.84821 +8366 4 9.23666 5.38964 32.029 2.44443 -3.9247 9.21777 +8367 6 16.6769 26.3146 18.0426 -28.7898 -24.0576 -1.25383 +8368 4 15.7763 26.5978 17.7405 22.2361 3.17889 2.46191 +8369 4 17.2688 27.0532 17.9767 7.52301 23.5471 -7.71583 +8370 6 5.12002 13.5179 11.5454 -28.2867 15.553 -42.5279 +8371 4 4.34318 13.4159 12.0982 -3.89331 -5.54815 13.62 +8372 4 4.69334 13.8537 10.6805 23.3071 -7.58808 40.5266 +8373 6 29.613 23.6535 8.07622 4.06305 -5.39054 -18.0309 +8374 4 29.2087 23.3655 8.89798 -2.48969 6.78204 1.65997 +8375 4 29.356 24.5861 7.97247 8.33853 -10.6544 5.22118 +8376 6 0.809058 7.56442 27.8431 6.90575 4.16885 -14.0934 +8377 4 0.916059 7.33161 28.7668 -1.2645 -7.40385 9.39857 +8378 4 1.47033 8.27499 27.7095 -9.19662 -21.8408 -1.77541 +8379 6 15.4183 9.78145 0.490529 10.0725 -7.13925 0.979932 +8380 4 16.087 9.43012 41.8027 -0.259761 -4.12548 -6.98761 +8381 4 15.4693 9.20893 1.26423 -1.27146 5.63374 6.96511 +8382 6 18.8191 0.059487 34.1187 -25.6574 -0.396319 -31.4644 +8383 4 18.4098 41.5755 33.3103 16.2128 4.97009 18.3796 +8384 4 18.5054 0.975155 34.0945 0.533414 5.37151 1.64989 +8385 6 18.7349 30.7803 29.1665 47.4813 -67.7405 25.7886 +8386 4 19.5534 30.6866 29.7899 -42.3671 12.2249 -32.0712 +8387 4 18.5184 31.6699 29.0545 -8.91834 48.7901 3.3651 +8388 6 48.4474 16.4903 36.136 -4.39653 9.55775 -4.4164 +8389 4 47.5651 16.9082 36.2181 15.0357 -0.381514 0.207393 +8390 4 48.471 16.1274 35.2331 3.08724 1.10756 7.15907 +8391 6 43.7979 0.472205 29.2706 42.555 -4.96452 -15.1149 +8392 4 42.8863 0.267919 29.38 -32.9664 -6.64218 10.9475 +8393 4 44.2792 41.5357 29.3524 -8.26894 11.2804 8.78801 +8394 6 16.7205 13.887 21.3769 2.19577 2.66609 -2.49996 +8395 4 16.2052 14.7022 21.5336 6.85381 -11.1318 0.719729 +8396 4 16.6911 13.4037 22.2072 -6.06459 1.50462 5.19021 +8397 6 17.3883 13.4356 26.2524 27.4966 3.2637 -26.6685 +8398 4 18.1303 13.5822 25.5825 -26.8694 -2.13737 32.6247 +8399 4 17.6394 12.6216 26.7148 -3.51452 -0.718268 0.201186 +8400 6 48.1557 10.2329 23.6958 7.66187 -11.6345 21.9365 +8401 4 48.0869 10.5828 24.5972 -4.20109 -8.3855 -4.21906 +8402 4 47.9242 10.9774 23.1563 3.12678 5.33996 -12.4543 +8403 6 28.2651 17.9126 17.8865 15.704 23.8601 -19.8805 +8404 4 29.0328 18.4581 17.6288 -8.16305 -6.08358 1.86534 +8405 4 28.6272 17.0995 18.2183 0.672722 -20.799 10.0784 +8406 6 54.0866 38.1772 23.6885 15.2416 -7.03948 -9.32302 +8407 4 0.015845 37.9236 23.4759 -13.1891 10.5947 7.1207 +8408 4 53.5403 37.6177 23.1226 -4.14834 -2.69562 5.50015 +8409 6 8.47885 18.3973 11.4073 -18.4373 -13.8141 42.9629 +8410 4 7.63335 18.6519 11.0416 -6.40415 6.02722 -6.48684 +8411 4 9.12927 18.583 10.7796 32.3175 8.52747 -41.6205 +8412 6 45.9451 12.8796 11.0371 -17.0736 -2.86831 -37.3051 +8413 4 46.6905 12.613 10.4807 4.61659 2.073 6.35499 +8414 4 45.2044 12.775 10.3831 8.06265 2.44535 24.075 +8415 6 16.2127 8.79404 14.0297 41.7324 -66.6139 22.361 +8416 4 15.4739 9.28873 13.8367 -45.7772 50.9633 -18.0772 +8417 4 17.0286 9.27652 14.012 9.93977 26.888 -8.08533 +8418 6 42.7214 13.3612 21.3881 16.6788 44.7105 -2.77317 +8419 4 41.8036 13.1589 21.3301 -20.1042 -28.5105 -1.62877 +8420 4 42.6833 14.2978 21.1276 5.52546 -8.26362 1.62797 +8421 6 21.0018 40.4256 16.4674 21.2457 -19.0828 1.73859 +8422 4 20.7372 40.049 17.3276 2.67731 3.65462 -7.46566 +8423 4 21.8606 39.9985 16.1939 -29.0987 10.293 9.55187 +8424 6 45.6337 11.4313 32.9356 51.1157 -40.0447 2.01383 +8425 4 46.3303 10.7696 33.2563 -29.172 28.0234 -20.2541 +8426 4 45.1866 11.676 33.7277 -20.3741 9.53259 21.5498 +8427 6 26.9484 8.87146 24.2965 48.4346 1.85391 18.4292 +8428 4 27.5311 9.68141 24.3337 -29.9021 -15.2605 -8.39328 +8429 4 27.4823 8.26118 24.8676 -16.4416 6.67878 -12.0087 +8430 6 18.977 2.43413 29.3663 0.758316 16.52 -7.40381 +8431 4 18.1944 2.4248 29.9271 -0.767207 -2.12047 7.99903 +8432 4 19.1173 3.36872 29.101 -3.03797 -9.07666 7.57415 +8433 6 8.2454 29.1679 19.723 -8.63488 -12.9151 21.1286 +8434 4 8.14448 28.8871 20.6627 3.14293 7.67545 -21.2948 +8435 4 7.83715 28.464 19.1969 -1.03495 3.62674 2.54809 +8436 6 9.03976 34.3129 18.6533 -7.54593 -6.72093 -3.09965 +8437 4 8.77081 34.2931 19.577 -0.177883 2.97642 -7.59668 +8438 4 9.06659 35.2455 18.4187 6.50563 1.62734 -4.46359 +8439 6 10.1892 11.9266 11.2355 -21.5107 11.0325 -1.739 +8440 4 10.2333 12.874 11.065 17.4692 -2.43612 -1.88546 +8441 4 9.23632 11.7983 11.121 5.09535 -6.80078 4.24402 +8442 6 35.7546 21.6858 36.1669 -23.2352 21.9394 0.834429 +8443 4 35.0265 22.3595 36.1433 18.2091 -18.4066 2.26802 +8444 4 36.3924 22.0173 36.8321 -9.99636 -6.87572 -9.75527 +8445 6 17.0812 12.5048 36.3903 -12.1142 25.6516 12.5185 +8446 4 17.3175 12.8308 37.2812 -0.49448 -9.18651 -10.1264 +8447 4 17.5662 11.7075 36.2155 7.76979 -20.5663 -1.07791 +8448 6 37.1566 13.0227 34.2843 -17.9764 -6.1284 -55.2853 +8449 4 36.5549 12.2662 34.3472 4.68366 1.60167 -17.3784 +8450 4 37.3932 13.1268 35.1567 14.9075 13.7384 64.605 +8451 6 38.9862 29.5501 13.2301 -1.89389 21.6683 -7.70005 +8452 4 38.7944 28.7085 12.8419 -2.19861 -17.9948 -10.7911 +8453 4 38.6501 29.4932 14.1174 1.27468 3.77518 16.782 +8454 6 0.176516 29.3495 29.4845 -12.5141 10.2637 -5.31555 +8455 4 0.737394 28.6151 29.2028 3.82179 3.49987 -8.15609 +8456 4 54.9814 29.9211 28.6995 5.57042 -17.7863 13.6106 +8457 6 15.9458 0.256833 12.7596 -44.0073 4.56069 2.48191 +8458 4 15.316 0.578271 12.0799 19.6091 -0.692249 -3.06606 +8459 4 15.3039 41.7798 13.3939 19.5978 -0.7471 3.56907 +8460 6 3.99127 11.9482 8.78851 -15.4327 -39.7622 32.4444 +8461 4 4.35413 11.6179 7.97869 6.27746 3.41828 -23.4587 +8462 4 3.98972 12.8788 8.75552 1.02746 43.1268 -6.73396 +8463 6 24.041 23.6822 19.9783 33.1595 11.366 0.122861 +8464 4 23.6132 22.8866 19.7159 -20.0299 -17.1205 -2.84168 +8465 4 23.4218 24.2757 20.3917 -9.46777 4.2557 4.80954 +8466 6 4.48057 2.29323 23.9805 -22.9759 10.1361 69.4322 +8467 4 4.73792 2.40802 23.1034 3.49419 10.2026 -52.1527 +8468 4 3.69711 2.85929 24.1902 11.7092 -10.5693 -13.4065 +8469 6 33.0966 27.663 33.8386 -28.073 -12.9468 -7.71443 +8470 4 33.3687 28.5694 33.7309 6.85765 13.8135 -2.76136 +8471 4 33.7449 27.1385 34.2981 13.436 1.78162 12.2729 +8472 6 11.3912 21.7129 6.08719 -17.5666 -2.19741 -2.39462 +8473 4 12.3323 21.6847 6.05692 28.5529 -3.65784 2.285 +8474 4 11.1694 22.1681 5.26899 -4.22105 -2.6604 -2.39966 +8475 6 37.2225 13.5364 23.6261 -18.6729 23.2035 4.88571 +8476 4 37.3138 14.0862 24.4412 -7.0733 -14.7121 -13.3014 +8477 4 37.9734 12.9786 23.5155 30.7338 -8.31921 -1.90296 +8478 6 5.00503 21.0366 33.3647 1.8453 38.5327 -33.3657 +8479 4 4.21257 21.4237 32.9267 15.1329 -13.9269 -2.57683 +8480 4 4.69097 20.5075 34.0602 -12.1996 -25.3348 31.8286 +8481 6 18.1998 37.5792 26.9379 10.6598 2.97497 -14.5277 +8482 4 17.7896 38.4267 27.1371 3.99806 -1.69574 -0.528064 +8483 4 18.8493 37.7746 26.2284 -6.0853 -8.42077 12.5802 +8484 6 19.7447 16.1537 4.6847 3.25094 -1.99961 -5.02271 +8485 4 18.927 15.8729 5.11398 3.02189 5.09699 3.93014 +8486 4 20.4865 15.8366 5.22215 -5.31395 3.35724 3.77112 +8487 6 54.074 32.5125 15.5854 10.3761 -37.3618 -30.9158 +8488 4 54.8842 32.2065 16.0104 -1.29748 4.29224 -6.87141 +8489 4 53.7047 33.0976 16.2003 -18.9781 34.1452 25.1436 +8490 6 31.1314 3.81684 36.7321 -0.834289 -2.49025 -7.10722 +8491 4 31.1103 4.02948 37.6722 -6.54843 -2.60835 4.18586 +8492 4 30.7135 2.95482 36.5673 3.74099 5.55874 7.56308 +8493 6 11.8386 14.3591 5.9475 31.6488 6.08621 47.6135 +8494 4 11.9235 13.4381 5.72501 -3.84758 -8.60837 -9.73648 +8495 4 12.4264 14.4198 6.78937 -30.0453 0.761866 -39.8937 +8496 6 30.4739 33.6971 6.46755 -23.3776 20.1936 16.0158 +8497 4 30.0841 33.0849 7.09297 -6.22519 -2.1618 10.9649 +8498 4 31.0937 33.1726 6.0102 25.8315 -23.5027 -25.5745 +8499 6 12.7945 0.536645 21.6661 -31.9857 18.4102 -14.2222 +8500 4 12.046 0.975194 21.1709 21.6431 -18.6961 6.09473 +8501 4 12.7507 0.998686 22.5059 13.427 -0.157027 11.5383 +8502 6 52.7685 7.22113 26.1957 6.97037 27.5507 21.845 +8503 4 53.4259 7.92282 26.4698 -21.5773 -21.2317 -16.9414 +8504 4 53.0823 6.78628 25.4103 4.46247 -3.68205 -10.7225 +8505 6 39.7279 40.8849 3.7445 22.9677 17.8938 -40.8272 +8506 4 39.3244 40.0392 3.76563 -12.6427 -25.5287 10.0743 +8507 4 39.6614 41.3038 4.58361 -3.65945 6.85452 27.763 +8508 6 20.1085 31.9188 21.9984 -7.05206 -5.67602 7.13377 +8509 4 19.4287 32.0842 22.6964 14.9272 -8.91322 -13.6161 +8510 4 20.3617 32.7769 21.6609 2.64243 15.0084 0.0829653 +8511 6 12.8674 35.0052 4.44359 43.5281 -46.0898 9.1613 +8512 4 12.2643 35.7062 4.40975 -34.4326 42.8527 -2.74399 +8513 4 13.784 35.3443 4.35073 -14.7319 6.47242 -4.65586 +8514 6 24.0589 33.6612 24.8588 9.55704 11.7193 -6.52578 +8515 4 23.7303 32.9012 24.3903 -5.13736 -12.3884 -10.0474 +8516 4 24.8786 33.8838 24.3903 -2.58553 -1.28908 -1.69824 +8517 6 40.1426 40.9082 22.7393 38.5538 -20.8809 37.5387 +8518 4 39.5402 41.0833 22.0513 -32.6743 7.60774 -19.3027 +8519 4 39.6696 40.5795 23.5226 -1.01773 2.4492 -9.99125 +8520 6 15.5532 2.81426 38.4448 -20.0738 34.0709 23.3703 +8521 4 14.8967 3.48174 38.7749 9.17215 -23.4566 -12.8824 +8522 4 16.1607 3.33672 37.9186 19.8661 -0.634992 -1.43825 +8523 6 41.016 9.18565 16.9561 17.4117 -10.7022 -18.9926 +8524 4 41.8597 8.69641 16.8054 -9.41989 12.8418 6.23764 +8525 4 40.6131 8.73354 17.6887 -9.17188 -2.41438 15.2761 +8526 6 43.1923 41.3931 9.58697 -22.3356 -19.1489 -3.62619 +8527 4 42.3612 40.9845 9.24256 14.3618 0.824315 8.65898 +8528 4 43.3433 0.185675 8.9708 1.58778 19.1204 -6.9238 +8529 6 24.903 37.9158 30.7914 -43.8554 -5.41491 21.3724 +8530 4 23.952 37.804 31.173 48.4757 4.96182 -14.1951 +8531 4 24.7905 38.4252 29.9913 -4.69729 3.46822 -12.8277 +8532 6 2.22055 5.32897 16.4318 -0.704957 11.5959 2.51569 +8533 4 1.8086 4.56809 16.8519 3.25773 -6.94195 4.1641 +8534 4 3.17492 5.17974 16.3235 -2.45649 -10.6256 -1.35481 +8535 6 1.39662 14.9371 19.1386 6.71081 10.2639 18.1623 +8536 4 0.558182 14.6006 18.8448 -10.0768 -10.7254 -15.2923 +8537 4 1.25744 14.8844 20.1022 8.06638 5.64899 -3.4629 +8538 6 34.3184 26.5435 23.7018 12.956 38.2174 -10.8067 +8539 4 33.6096 26.6326 23.0506 -6.28704 -5.42218 7.19498 +8540 4 34.253 25.729 24.1673 -8.0715 -30.4977 4.91012 +8541 6 41.932 21.8144 37.5476 -28.1346 24.458 10.6264 +8542 4 41.9653 21.2973 38.3662 8.82952 -0.726087 -9.88338 +8543 4 41.2985 22.5209 37.8344 14.7394 -10.5077 -10.9774 +8544 6 39.4289 37.6722 12.6363 -7.06663 36.6798 -8.56095 +8545 4 38.7214 38.0767 13.1674 9.12422 -13.2372 3.4836 +8546 4 39.8791 38.4903 12.2996 -0.376717 -30.7746 7.3995 +8547 6 30.2308 35.8744 2.88429 56.3256 -5.17531 19.584 +8548 4 29.7395 35.078 2.8871 -14.5394 -27.2578 -4.40621 +8549 4 29.6846 36.541 2.55195 -33.266 39.3858 -14.7027 +8550 6 50.3691 12.2996 11.0379 -10.7742 -32.245 -38.7061 +8551 4 50.5492 13.1381 11.4098 4.20277 26.7051 25.7379 +8552 4 50.0731 11.6929 11.7162 -2.05651 -3.66514 15.0978 +8553 6 38.4203 1.52686 34.6552 6.3891 -23.1477 32.9209 +8554 4 38.2942 1.9363 33.8354 -7.66336 30.6162 -40.7111 +8555 4 38.1079 0.632206 34.5078 -6.35148 -11.0336 -1.97829 +8556 6 23.4679 32.2557 29.2149 -43.4567 -12.6916 53.2324 +8557 4 24.0296 32.8423 28.7424 12.6247 17.2837 -9.6693 +8558 4 23.1232 32.6929 30.0761 24.9901 -11.6617 -44.232 +8559 6 36.561 38.8488 8.89417 42.7368 2.70764 46.8348 +8560 4 35.962 39.5202 8.64255 -29.9788 24.4889 -23.0747 +8561 4 36.8832 39.1244 9.78764 -11.193 -6.37855 -17.8717 +8562 6 35.882 15.8491 32.4345 4.38917 24.4094 -11.8898 +8563 4 36.1253 15.4284 33.2547 4.1797 -3.844 11.2859 +8564 4 36.4849 16.63 32.3181 -12.6028 -21.8682 2.29862 +8565 6 22.2747 21.8257 41.5848 1.63659 45.0851 -0.0273952 +8566 4 22.1351 22.8132 41.5538 -4.13496 -33.3395 13.1468 +8567 4 23.0832 21.7834 41.079 15.3069 -18.439 -3.51535 +8568 6 24.3693 38.6933 37.0124 5.99709 22.8296 -9.01594 +8569 4 25.2224 39.1901 37.0147 -13.2325 -18.2305 -0.0611307 +8570 4 24.4452 38.0141 37.6805 1.8393 -10.9749 7.25289 +8571 6 45.85 22.0674 16.0435 -6.35855 -11.009 -33.5755 +8572 4 46.1693 22.2375 15.1223 -5.70657 5.73574 25.2515 +8573 4 45.3177 21.2496 15.9445 13.424 8.98362 5.88408 +8574 6 34.0938 26.1451 39.6028 29.3502 -8.72422 32.5359 +8575 4 33.1775 26.2044 39.4639 -36.6108 3.5864 -15.8394 +8576 4 34.1454 26.1252 40.583 9.60862 3.8872 -14.9166 +8577 6 7.22316 36.161 23.2803 -75.9344 2.48999 -44.2827 +8578 4 7.2061 37.0658 22.9632 2.60813 8.07149 -4.69042 +8579 4 7.98979 36.1134 23.7455 79.8131 -8.28428 52.3852 +8580 6 29.1469 40.7664 9.14908 25.9603 -62.9641 -41.536 +8581 4 29.104 40.2522 8.28913 -11.1672 35.4313 19.904 +8582 4 29.7179 40.1086 9.59652 -3.22944 23.7461 21.8778 +8583 6 29.3725 11.2348 1.3024 -38.7794 14.8627 17.4065 +8584 4 28.4703 11.3821 0.891273 31.6728 -0.63192 16.6295 +8585 4 29.2803 11.4968 2.26097 5.36173 -12.1272 -32.3877 +8586 6 30.9813 3.70043 14.0775 0.393287 -12.1193 -7.6118 +8587 4 31.3533 2.81844 14.3971 -7.37725 32.1126 -17.4345 +8588 4 30.796 3.71521 13.098 8.52465 -17.2224 25.8707 +8589 6 29.7018 15.2871 38.2765 -11.7342 18.5436 -44.4423 +8590 4 30.2882 15.1814 38.9925 24.3773 -7.28175 32.8118 +8591 4 30.1059 15.9805 37.6877 -12.7379 -16.9908 17.8861 +8592 6 36.618 0.316233 29.1564 -1.13478 17.6011 -18.8673 +8593 4 37.4497 0.805382 29.2328 -0.537074 -5.31334 10.7084 +8594 4 36.0611 0.935156 28.6408 3.38103 -20.3125 11.7491 +8595 6 47.6566 0.117823 23.249 5.11875 5.73062 -10.5794 +8596 4 46.969 0.414744 23.8324 -12.4062 9.53281 16.9836 +8597 4 47.4018 41.1354 23.0496 0.315762 -17.3342 0.264415 +8598 6 7.91605 37.1729 29.9478 9.96828 38.7234 29.3851 +8599 4 7.8238 37.3188 30.9485 4.22886 -13.4646 -46.5453 +8600 4 8.48708 37.9472 29.6677 -24.8232 -29.7333 9.09982 +8601 6 38.925 24.2263 12.6374 28.6028 -18.1679 -25.4959 +8602 4 37.978 24.1747 12.7226 -16.6271 -1.4443 2.40459 +8603 4 39.1586 23.5255 11.9538 -9.24307 26.9603 22.464 +8604 6 21.3053 26.2545 36.7859 14.9917 45.9325 1.16 +8605 4 20.8074 25.7232 36.1994 -14.2562 -21.9874 -17.8757 +8606 4 21.6248 25.6951 37.4625 3.91421 -21.0802 23.8691 +8607 6 28.2258 23.3284 24.9888 19.6442 1.87868 9.60148 +8608 4 28.2493 24.0261 25.6588 -3.93467 -3.60043 -2.01642 +8609 4 29.1002 22.8932 25.0573 -18.3502 1.43704 -4.70914 +8610 6 38.4116 39.5691 14.5896 29.669 -4.24194 25.1928 +8611 4 38.4978 38.8692 15.3261 -6.52385 31.9806 -37.1925 +8612 4 39.2924 40.0897 14.6163 -46.5668 -30.9815 -6.21074 +8613 6 26.0432 5.99751 38.1148 44.5658 1.98351 30.7371 +8614 4 26.452 6.86444 38.1066 -12.5768 15.2327 -11.4433 +8615 4 26.7959 5.51316 38.5398 -27.2991 -6.53191 -16.0548 +8616 6 52.1237 17.2497 22.5073 -27.4301 16.765 14.7973 +8617 4 52.9399 17.665 22.2571 16.5652 5.20466 -11.3284 +8618 4 52.1578 16.3131 22.3678 7.8945 -19.2066 -9.92552 +8619 6 39.5302 30.1999 31.4498 -15.3908 2.56685 75.4769 +8620 4 40.0207 30.5437 32.2484 0.473519 -4.28305 -35.1019 +8621 4 38.713 29.8928 31.926 18.6512 10.8404 -28.7426 +8622 6 19.6503 6.93083 12.7623 15.8343 -24.4908 21.6207 +8623 4 19.8732 6.46228 13.5959 -20.1786 11.9342 -5.76682 +8624 4 20.303 6.55009 12.1776 -0.0209149 2.55819 -14.5973 +8625 6 32.4196 37.4972 40.0987 12.4446 10.4582 -32.0511 +8626 4 32.8186 36.647 40.0719 9.51079 -23.9505 -16.9607 +8627 4 32.1638 37.519 40.9804 -20.9873 13.1856 56.2462 +8628 6 39.7646 0.344956 6.09395 -0.813604 -13.3118 11.6504 +8629 4 40.0929 1.25666 6.05063 3.72657 -6.06719 5.14874 +8630 4 40.1279 41.7919 6.88268 -2.2039 13.7644 -10.8213 +8631 6 28.7754 10.1494 29.1547 6.27663 8.45441 -17.0952 +8632 4 27.8341 10.1814 28.9557 -5.13507 -0.906004 3.81537 +8633 4 28.9096 9.91312 30.0774 -3.02611 -6.60467 -0.689697 +8634 6 28.3509 21.0738 10.6423 20.1214 -0.517468 -23.7169 +8635 4 28.7452 21.9678 10.604 -10.1652 -7.70852 11.001 +8636 4 28.9796 20.5469 10.1008 -17.263 7.26144 14.8814 +8637 6 27.0689 28.6853 20.8654 35.4789 -5.63144 4.47554 +8638 4 27.7442 29.2307 21.3162 -7.53329 -4.62114 -3.00727 +8639 4 26.2324 28.9644 21.1916 -29.8949 8.87289 15.491 +8640 6 39.6884 13.9755 33.4499 14.6401 2.99861 16.5486 +8641 4 40.0373 13.7827 34.3426 -3.85296 -1.51256 -14.2832 +8642 4 38.7457 13.8219 33.5285 -9.87208 -9.87778 -3.27097 +8643 6 25.4679 11.6581 34.316 -5.2989 -28.5582 40.5924 +8644 4 24.7613 11.1605 34.7897 20.9725 -0.466275 -6.59756 +8645 4 25.003 12.0579 33.6214 -16.717 25.3404 -32.2266 +8646 6 27.5101 37.647 21.4263 -39.7295 -31.2682 -35.969 +8647 4 28.2375 37.1633 21.0518 17.2189 -6.02702 -9.55939 +8648 4 27.8241 38.1534 22.1272 30.3423 24.6719 41.8853 +8649 6 30.5838 20.0489 28.6446 73.221 13.9737 -1.42059 +8650 4 31.1441 19.3945 29.1273 -28.9524 12.9537 -8.0961 +8651 4 29.6632 19.9528 28.6439 -45.0502 -19.2043 6.90743 +8652 6 42.3833 1.8554 14.9243 13.367 3.08275 38.4467 +8653 4 41.8907 2.29225 15.634 5.99337 6.74303 1.17955 +8654 4 41.7769 1.84183 14.2131 -17.6385 -4.20156 -32.9301 +8655 6 12.1633 12.5377 19.5325 -23.0245 -19.867 -11.1113 +8656 4 12.9521 12.0237 19.3369 9.43068 0.576721 5.46819 +8657 4 11.4219 11.8853 19.4518 12.4737 16.4774 1.27947 +8658 6 19.216 1.20416 16.3541 12.5689 2.54581 22.2585 +8659 4 19.6937 0.628292 16.9879 -4.91383 6.35485 -14.1526 +8660 4 19.7889 1.98236 16.2594 -2.22189 -4.72354 -7.2618 +8661 6 9.47695 16.1439 27.6873 23.0793 15.684 -40.8775 +8662 4 9.87411 15.9669 26.7875 -8.00596 11.4199 30.6292 +8663 4 9.27844 15.2819 28.0019 -12.6146 -24.0632 14.4486 +8664 6 40.4558 26.1873 24.7848 -5.87099 -8.07067 -10.9608 +8665 4 40.3772 26.6753 25.6381 -3.45584 0.121614 -18.2296 +8666 4 40.075 26.6842 24.0102 9.21367 0.234889 33.0434 +8667 6 47.6742 17.6493 18.027 -37.0889 26.6143 -3.73366 +8668 4 48.2089 18.0323 18.7522 -4.76487 -3.2939 -8.20899 +8669 4 46.8388 18.2201 17.9217 41.9344 -19.3622 12.4897 +8670 6 36.6073 25.2802 4.19388 18.2149 -9.73143 -24.5863 +8671 4 36.604 25.3887 5.14943 -0.00537736 13.7381 3.83127 +8672 4 37.3627 25.7621 3.76942 -18.9403 0.329358 18.8416 +8673 6 39.5721 35.375 29.6682 7.39129 29.0443 4.37935 +8674 4 38.9992 34.6325 29.7528 -8.39079 -18.7886 -5.10368 +8675 4 39.3389 35.9401 30.4162 6.41301 -4.37294 -4.4287 +8676 6 0.402862 14.6299 13.3406 12.3375 -5.37043 -32.3015 +8677 4 54.737 15.2477 13.6388 -5.18731 7.44473 4.40324 +8678 4 0.540834 14.0191 14.0401 1.19186 -14.994 25.3978 +8679 6 12.2127 27.3484 8.43247 -29.2387 -0.771708 1.75024 +8680 4 12.965 26.7512 8.46983 14.5311 5.0326 6.8656 +8681 4 12.3156 28.1607 8.97491 11.1816 -11.3427 -11.9337 +8682 6 36.8986 14.8167 21.1188 31.0797 27.7575 -31.2238 +8683 4 37.0397 14.394 21.9547 2.6333 -10.7207 26.6181 +8684 4 37.7308 15.3371 20.9125 -24.2604 -24.0664 4.77074 +8685 6 20.8464 4.94114 21.1044 31.4042 5.97012 13.2179 +8686 4 20.3644 5.60924 21.5958 -5.50293 4.43366 -4.7096 +8687 4 21.773 5.03668 21.4416 -23.5272 -13.3128 -11.683 +8688 6 36.7544 1.79945 7.61694 -30.3574 47.6061 45.3867 +8689 4 36.327 2.6686 7.87118 16.8784 -26.1974 -29.8241 +8690 4 36.8428 1.50799 8.53455 15.1793 -22.3797 -11.8231 +8691 6 12.2439 31.5023 37.4569 -32.4985 -2.96535 6.06153 +8692 4 12.7586 31.1596 36.7365 10.4364 1.05198 -9.11954 +8693 4 11.3919 31.0227 37.3953 11.2973 8.58078 9.3944 +8694 6 38.9908 41.586 16.881 -5.73716 8.1645 -10.5856 +8695 4 39.3046 41.7073 15.9766 4.30886 -9.33368 3.06156 +8696 4 39.3667 0.405687 17.3669 3.77504 10.3777 9.96207 +8697 6 31.8904 27.2678 22.2602 -2.97266 4.85738 -46.2508 +8698 4 31.2122 26.6002 22.3915 1.88455 0.488126 10.0993 +8699 4 31.7489 27.4981 21.2895 3.71213 -3.79941 38.8104 +8700 6 42.7405 9.18554 25.589 -22.1194 -12.6454 -9.25487 +8701 4 42.0872 8.82691 24.9599 0.650449 1.17306 7.26361 +8702 4 43.4011 9.54846 25.0154 21.3216 10.0262 -4.62936 +8703 6 50.9383 28.1736 25.3544 -13.6318 0.0171378 28.1732 +8704 4 50.4953 27.5553 24.7803 -5.9639 1.72187 -15.2616 +8705 4 50.5272 27.9992 26.2251 14.2447 5.57945 -12.3971 +8706 6 43.1888 19.6578 30.9105 -66.6531 23.7889 25.5358 +8707 4 44.0873 19.829 30.8982 70.1332 9.75906 -5.84371 +8708 4 42.7965 20.4661 31.3425 9.97757 -17.7871 -10.1322 +8709 6 30.6644 14.0457 40.7997 -18.1309 16.7334 54.243 +8710 4 30.3214 14.3504 41.7092 15.0959 -2.90855 -40.5845 +8711 4 30.1739 13.231 40.7145 -1.19418 -16.8866 -12.4659 +8712 6 20.9131 15.4897 23.0235 5.61878 12.7036 12.8066 +8713 4 20.368 16.1905 23.4302 1.66694 -9.32372 -6.67403 +8714 4 21.8218 15.751 23.2692 -7.37195 -9.57776 -6.18749 +8715 6 34.2171 0.764056 35.8253 8.40959 -35.3498 44.9304 +8716 4 34.6567 1.46863 36.3417 -5.08936 -9.30099 -7.81199 +8717 4 34.1194 41.866 36.4755 2.29033 39.9746 -37.3302 +8718 6 38.9162 36.9098 35.9203 10.0793 6.80115 3.36275 +8719 4 39.7784 37.1612 36.3284 -16.0364 -11.2649 -5.21842 +8720 4 38.6132 36.0588 36.2696 9.66804 2.35098 0.533126 +8721 6 45.1336 25.2146 22.7744 -28.8992 3.863 21.2581 +8722 4 44.1561 25.0943 22.7165 17.1243 8.87651 18.653 +8723 4 45.3983 24.7563 22.0047 17.0602 -12.3694 -29.5411 +8724 6 40.597 0.8134 35.9421 3.227 69.6319 -3.88491 +8725 4 40.5509 41.8059 36.0096 -6.03355 -53.2669 -4.53187 +8726 4 39.9427 1.13471 35.2813 10.0151 -17.6297 16.5691 +8727 6 11.0455 28.3465 35.0235 9.7668 1.71998 -0.601403 +8728 4 10.9819 27.7367 35.7737 -0.960779 4.073 1.47136 +8729 4 10.3922 29.0422 35.1677 -11.8786 -4.48184 3.12795 +8730 6 20.2051 13.5934 35.8566 39.7213 -43.4527 45.4399 +8731 4 19.4813 14.0017 35.4777 -48.9883 30.031 -35.164 +8732 4 20.9868 14.0394 35.5673 14.4182 15.1 -18.5178 +8733 6 39.6245 5.13776 1.76997 -0.951619 9.89005 21.073 +8734 4 38.8252 4.77089 1.41386 -14.9185 -6.12031 -3.7056 +8735 4 40.3018 4.93211 1.13633 15.4903 5.30459 -14.5773 +8736 6 30.2698 30.8736 32.4375 -6.71798 15.6036 14.0469 +8737 4 29.6901 31.1438 33.1751 5.76607 1.99955 -8.25679 +8738 4 29.7896 30.1731 32.0039 1.14172 -17.9152 -6.50707 +8739 6 14.5598 11.0088 22.8703 10.5759 -0.53797 13.7125 +8740 4 15.2344 11.6195 23.3114 -32.0235 -23.0075 -11.5695 +8741 4 13.848 10.7777 23.5118 19.1574 10.2796 -1.34673 +8742 6 20.7379 13.9443 3.00881 5.16887 -45.0314 -26.4616 +8743 4 19.9261 13.6658 2.50706 22.866 18.233 23.793 +8744 4 20.5244 14.6819 3.55007 -16.1173 25.3417 12.2311 +8745 6 41.3029 4.28468 12.6203 -8.04128 10.917 21.7417 +8746 4 40.6152 3.63858 12.7642 -6.82471 -4.23516 2.09603 +8747 4 41.6484 4.11485 11.7651 11.719 -9.67534 -28.974 +8748 6 10.8581 24.7328 21.7161 -39.3585 -15.8792 -33.4515 +8749 4 10.0068 24.8598 21.1989 28.1112 14.2693 20.1969 +8750 4 11.1639 23.9123 21.3137 10.3572 -6.50453 7.69671 +8751 6 53.5762 20.8825 34.3773 -29.6915 -0.0415475 -3.94304 +8752 4 54.5085 20.795 34.3185 33.8519 4.29786 -2.30511 +8753 4 53.2552 20.0612 34.7861 8.83511 12.9473 -9.59804 +8754 6 14.8838 4.84499 30.449 -1.65326 0.839716 -13.8987 +8755 4 14.8578 5.00753 29.4799 -4.93385 -7.75961 17.951 +8756 4 14.5437 3.94124 30.5804 2.28716 7.27432 -2.63088 +8757 6 48.9137 37.1159 13.1232 -44.1315 32.6594 -31.0851 +8758 4 47.9268 37.1149 13.1949 24.5681 4.85746 10.1076 +8759 4 49.2024 36.4546 13.7037 17.9017 -30.2536 24.0784 +8760 6 26.8017 19.3068 7.5379 -15.1037 -1.6612 14.6377 +8761 4 27.3245 18.5243 7.34583 -2.01051 -6.65035 -9.19035 +8762 4 27.3053 20.0577 7.2492 18.4232 10.5976 -10.0514 +8763 6 17.631 11.9383 39.0904 -43.3265 13.8677 10.122 +8764 4 18.4941 11.6307 38.9203 38.4816 -13.6738 2.54756 +8765 4 17.5009 12.0978 40.0481 6.31677 -1.58465 -10.4285 +8766 6 49.9233 14.5931 8.61354 5.83785 -36.2985 -8.08798 +8767 4 49.214 13.9285 8.60404 6.89175 6.08198 5.75816 +8768 4 49.5175 15.3796 8.93642 -5.42274 33.9852 6.11405 +8769 6 32.3642 34.9667 31.5078 2.95354 23.7899 20.5819 +8770 4 32.072 34.4222 30.8036 -4.84614 -18.7532 -16.6478 +8771 4 32.4643 35.8463 31.1217 -0.970967 -0.757054 5.3462 +8772 6 11.8286 22.2266 21.3061 -17.2258 -15.6378 -41.9552 +8773 4 12.2171 21.6669 20.5638 -11.8041 19.7065 26.8676 +8774 4 12.3859 22.1258 22.0497 29.6948 -3.02551 21.8379 +8775 6 33.8509 9.96106 13.6416 -14.3875 -24.3714 -53.1057 +8776 4 33.0123 9.50508 13.4028 8.15621 17.9807 22.2309 +8777 4 34.3201 9.78154 12.7883 7.50726 12.1846 28.7729 +8778 6 25.5192 36.3946 1.51103 -10.4602 3.19395 -11.4439 +8779 4 26.0842 36.7323 0.810141 8.62195 6.50952 5.56913 +8780 4 24.6933 36.9065 1.40961 6.72848 -10.059 1.65156 +8781 6 26.2721 10.5411 9.76409 -19.2005 -4.19702 2.88354 +8782 4 25.6096 11.193 9.42675 5.9346 -6.99241 18.1855 +8783 4 25.839 9.94226 10.4354 7.43867 25.8511 -14.7334 +8784 6 25.016 0.794303 40.8954 13.3669 6.17095 4.00755 +8785 4 25.3682 0.342397 40.1084 -6.19889 9.04785 1.09472 +8786 4 25.4075 1.69244 40.9338 -2.19893 -14.7289 -5.24662 +8787 6 46.2434 3.93626 24.8203 6.94819 -22.6825 -8.03363 +8788 4 46.3834 4.04208 23.8743 3.61713 6.01616 -2.12387 +8789 4 46.2394 2.96647 24.9181 -8.37252 7.22853 3.62774 +8790 6 21.5889 13.6037 29.2057 4.95103 8.76674 17.4208 +8791 4 21.6019 14.3052 29.8879 -2.51331 -9.966 -5.68557 +8792 4 21.3126 14.082 28.4253 -2.16645 0.501775 -6.52993 +8793 6 36.7737 38.3803 0.360926 -13.0762 -25.442 -6.6792 +8794 4 36.4499 39.0355 0.978203 -4.80976 12.188 0.88021 +8795 4 36.0266 37.7487 0.22189 15.835 12.8395 4.19355 +8796 6 19.3086 17.6338 24.0617 47.0109 35.6134 -17.5995 +8797 4 18.4263 17.3722 24.1632 -50.3154 -15.1751 2.93786 +8798 4 19.3137 18.3511 23.365 -2.62926 -22.9616 14.087 +8799 6 23.1803 12.6945 3.50697 -12.4047 4.12184 -0.296296 +8800 4 22.2521 12.9621 3.30307 10.5621 -3.58256 -0.535563 +8801 4 23.3663 11.8631 3.0578 -9.23841 -1.30096 -1.53094 +8802 6 37.8891 8.88353 35.4651 -18.9945 -25.3999 -47.3866 +8803 4 38.8166 8.83127 35.1934 2.77199 2.98421 7.2207 +8804 4 37.4068 8.32521 34.752 23.9265 29.6152 37.0755 +8805 6 14.3237 15.1253 36.1844 10.7536 -1.62675 -12.1114 +8806 4 15.0418 15.7291 36.3902 7.37284 -3.65767 0.0646607 +8807 4 13.765 15.154 36.9379 -17.7819 2.51157 18.8211 +8808 6 35.0801 0.941274 33.018 -10.8249 30.7834 33.3167 +8809 4 34.9269 1.883 33.2395 6.71896 -7.58638 -28.1375 +8810 4 34.9733 0.615676 33.9226 0.339269 -19.4543 -11.259 +8811 6 50.9271 0.518298 17.9933 -4.01299 -8.33658 -1.61011 +8812 4 50.7551 1.39133 17.5891 -0.713529 -12.5397 8.99793 +8813 4 50.17 41.8323 17.8017 14.8721 13.6567 -6.57092 +8814 6 26.2328 30.5636 0.934374 -8.95911 39.2037 50.9017 +8815 4 26.9657 31.1139 1.27364 -12.5333 -13.1029 -5.86431 +8816 4 26.5352 30.0815 0.207089 19.4446 -20.9762 -37.1203 +8817 6 18.5681 38.3031 4.5613 16.0408 -0.4472 -12.493 +8818 4 17.6336 38.3732 4.40187 -16.7548 5.85511 1.82222 +8819 4 18.9561 38.7121 3.75593 -0.616515 -6.35836 15.3023 +8820 6 31.1349 5.07457 4.1166 35.5071 -12.4218 -11.0008 +8821 4 31.9258 4.61163 4.53765 -37.2933 13.7034 -13.5003 +8822 4 31.2792 5.02565 3.1391 -9.10044 -1.2591 17.9933 +8823 6 26.4378 21.892 1.49191 0.117022 -23.7737 9.75083 +8824 4 26.3504 22.7277 1.07049 4.38069 30.3527 -12.7348 +8825 4 27.3618 21.6023 1.50897 -0.762137 4.81239 -9.09803 +8826 6 39.2154 11.7026 22.7855 15.1366 1.14561 24.1899 +8827 4 39.8619 11.6546 23.5153 -3.42244 7.72178 -8.31759 +8828 4 38.7922 10.855 22.8508 -11.0077 -10.6036 -7.38167 +8829 6 13.6049 36.3215 30.6697 16.8779 70.0034 -37.8159 +8830 4 13.9417 37.1302 31.1268 -10.116 -30.1168 -5.71441 +8831 4 13.4922 35.6039 31.2515 -3.36872 -19.2676 30.0327 +8832 6 50.5831 9.86782 9.34675 -39.9446 -18.2052 0.719337 +8833 4 49.679 9.5553 9.65542 27.7691 6.62521 -8.8993 +8834 4 50.7343 10.6656 9.84378 7.47556 12.1458 9.31829 +8835 6 49.6659 40.3022 22.5839 -5.95569 -23.2057 2.00246 +8836 4 49.9088 39.3695 22.3976 1.04597 17.1639 -6.42107 +8837 4 49.3089 40.2511 23.4853 9.00681 3.37443 -0.55643 +8838 6 7.21026 41.318 28.8937 -13.882 28.5523 32.2899 +8839 4 7.13277 41.6426 29.851 5.74914 -19.7174 -37.6289 +8840 4 7.14599 0.215754 28.3517 11.7183 -8.26627 3.5395 +8841 6 13.0317 18.008 25.3351 57.1177 45.3919 41.6622 +8842 4 13.702 18.0765 24.6297 -18.9881 -2.87884 -2.05071 +8843 4 13.5608 18.5052 26.1022 -41.5403 -41.2906 -37.5185 +8844 6 50.0508 19.5822 2.43378 8.05757 -12.3534 -25.4868 +8845 4 50.6415 19.2321 1.70522 -9.91294 15.3245 28.3035 +8846 4 50.4964 20.3068 2.88656 9.48594 2.0046 -2.18375 +8847 6 28.3417 40.9623 24.5247 28.1527 -9.28969 -2.11238 +8848 4 28.8808 40.6229 23.7869 -8.53201 1.00989 5.926 +8849 4 27.851 41.6822 24.1702 -24.0642 17.3603 -12.6153 +8850 6 19.4173 5.36544 29.5282 -16.7292 -1.42659 17.4998 +8851 4 20.0576 6.03033 29.2802 12.6037 1.87093 -5.71578 +8852 4 18.8017 5.84191 30.1159 0.735032 -8.12986 -7.95209 +8853 6 35.3107 40.1454 22.2712 -2.40765 19.7984 -7.699 +8854 4 35.7006 39.9699 23.1142 6.54418 -16.9762 14.0951 +8855 4 35.2702 41.1078 22.294 -0.592679 0.794763 -5.20647 +8856 6 16.1889 33.7724 9.7458 10.3229 10.2088 29.582 +8857 4 15.8959 33.2543 9.01299 -6.07516 -13.8809 -16.7379 +8858 4 15.6715 34.5759 9.82028 -7.73583 2.776 -7.11592 +8859 6 17.3675 40.6445 20.2267 0.0256395 24.2963 -9.09373 +8860 4 17.2094 39.7816 20.6122 1.5629 -5.58702 6.23448 +8861 4 17.4758 41.3298 20.9152 1.51783 -13.2527 0.49298 +8862 6 20.5171 9.72867 9.58726 35.059 7.05341 -25.1666 +8863 4 21.2226 9.96362 10.213 -13.2653 -0.810893 -5.91795 +8864 4 19.8248 9.38464 10.113 -26.7953 -13.816 19.6743 +8865 6 47.4426 20.1922 21.3765 55.2231 -18.8128 34.629 +8866 4 48.295 19.6294 21.3384 -41.3243 22.9169 -3.74061 +8867 4 46.9816 20.0754 20.5659 -14.9725 -5.50706 -31.0177 +8868 6 38.4071 40.79 37.8146 12.3234 -22.6201 -9.80787 +8869 4 38.1404 41.7017 37.8605 -3.64711 23.1989 -4.06141 +8870 4 38.2696 40.4362 38.6954 -10.1247 -0.131598 9.15413 +8871 6 4.78578 1.94641 13.1038 0.280311 5.55092 -8.42179 +8872 4 4.79931 1.2475 12.4246 2.88607 5.75183 11.0778 +8873 4 4.58324 1.57529 13.9639 -2.31824 -10.9024 4.61034 +8874 6 46.8249 29.0091 2.16845 3.76482 2.94797 40.2579 +8875 4 46.7332 29.1215 3.14399 -15.0191 0.321828 -28.5005 +8876 4 47.6691 28.5689 2.15078 10.7116 -9.65214 -17.1948 +8877 6 37.4359 26.1653 25.6478 9.30824 1.4869 -5.75173 +8878 4 37.1837 25.5346 26.3178 -5.80587 -7.25577 3.90549 +8879 4 36.6384 26.5534 25.3025 -7.59782 4.42715 -0.0787482 +8880 6 27.3269 4.19583 19.442 5.96538 17.8772 -24.7701 +8881 4 28.0114 4.58146 18.8428 -3.77368 -14.8915 15.8068 +8882 4 26.5277 4.61529 19.0816 -6.14884 -6.84507 9.70558 +8883 6 29.57 35.1706 32.6629 9.65469 -19.4491 -13.9626 +8884 4 29.5306 34.4116 32.0191 -0.1659 24.8691 21.1709 +8885 4 30.4743 35.5004 32.5856 -0.51053 -0.290213 -2.43375 +8886 6 51.6097 27.3863 34.6091 -31.2455 30.913 9.06642 +8887 4 51.929 26.6019 35 16.42 -40.5282 7.55135 +8888 4 52.0725 27.582 33.8009 7.9649 -1.59603 -13.3915 +8889 6 26.2078 15.7281 22.6941 16.538 -21.7488 31.7554 +8890 4 25.9667 16.5615 22.3191 -8.70869 23.0893 -12.8942 +8891 4 26.0629 14.9994 22.0993 -9.54979 -3.97748 -17.7982 +8892 6 36.1239 41.1986 15.4707 -7.45359 -19.8962 -4.3143 +8893 4 35.6999 40.3419 15.2987 -9.47391 11.3121 -0.409552 +8894 4 37.0386 40.9374 15.4513 15.7433 3.85103 -0.545832 +8895 6 18.465 8.81345 11.2165 5.38391 10.0618 1.17025 +8896 4 18.7987 8.15135 11.8182 8.53154 -1.35082 11.1952 +8897 4 17.7161 8.38168 10.8393 -16.7411 -2.38381 -11.2186 +8898 6 30.2088 21.3096 23.2049 -11.6688 7.62645 -9.73036 +8899 4 29.9671 22.1993 22.9248 4.97058 -0.914249 3.78278 +8900 4 29.5299 20.7541 22.7893 7.94877 -1.13118 2.47612 +8901 6 22.73 2.20521 34.8374 1.74432 -25.8699 49.3747 +8902 4 22.3572 1.29354 34.8889 6.16039 22.5731 -10.8251 +8903 4 22.7018 2.4887 33.9486 -6.75325 10.5307 -40.1895 +8904 6 12.6909 2.75059 12.3422 -14.3125 16.3183 -13.6311 +8905 4 12.533 3.61796 11.8786 11.7453 -23.2619 14.9881 +8906 4 13.1336 2.19907 11.6816 1.83842 1.45343 3.2847 +8907 6 24.107 30.0639 14.5719 -73.5796 11.8292 4.65098 +8908 4 23.699 30.7611 15.1345 32.1371 -0.343623 -0.31889 +8909 4 23.2337 29.7156 14.2286 43.085 -3.68866 -7.89372 +8910 6 0.015177 27.9048 22.8533 -2.756 -4.53229 -2.63487 +8911 4 54.6492 28.3778 23.623 -8.36257 -3.01834 -6.1652 +8912 4 54.216 27.6514 22.3224 8.23112 8.70814 10.2495 +8913 6 12.3617 4.4844 25.9108 40.9735 -25.7794 -17.3291 +8914 4 12.201 5.40791 25.8162 -22.6464 21.2272 1.21762 +8915 4 11.6198 4.00067 26.267 -15.5784 4.93476 10.9426 +8916 6 50.6578 14.4652 5.91353 -13.9437 -6.30553 43.3918 +8917 4 51.4397 15.014 5.76935 2.55266 2.90763 -3.8133 +8918 4 50.4787 14.4827 6.92851 9.15248 3.54798 -49.9389 +8919 6 52.5668 22.873 20.1428 -12.6564 -29.9263 -28.8801 +8920 4 52.956 23.3393 20.8718 4.45243 13.9606 14.107 +8921 4 52.7899 23.3428 19.3246 -0.129831 10.341 11.583 +8922 6 43.5892 16.524 12.8775 29.595 -3.78245 -19.1347 +8923 4 44.3058 16.0087 12.3806 -28.6005 27.9094 23.6723 +8924 4 42.7982 16.4888 12.3437 -11.2315 -8.54457 -10.2035 +8925 6 15.9661 16.7487 40.5866 1.44034 32.7745 -1.20572 +8926 4 16.4126 17.3388 39.9207 -12.1014 -18.8104 17.452 +8927 4 15.5985 17.3766 41.2587 12.5036 -14.614 -16.5617 +8928 6 23.4158 18.8712 23.8473 -16.0774 -11.4939 3.2157 +8929 4 23.4518 19.2692 24.728 -0.157295 3.62127 -3.85719 +8930 4 22.4941 18.9757 23.5436 12.0607 -0.266031 2.57498 +8931 6 46.4178 3.27548 31.8952 19.5415 -1.29071 -17.2416 +8932 4 45.5866 3.26999 31.4067 -8.61336 -0.166695 4.01481 +8933 4 46.2657 3.3297 32.8359 -5.35267 1.32166 2.09612 +8934 6 43.4045 41.0584 12.2875 -8.04746 -23.5947 4.76735 +8935 4 43.6693 41.8276 12.7696 6.05224 12.9314 10.8988 +8936 4 43.5172 41.2728 11.3626 0.904796 3.93503 -13.2342 +8937 6 7.4976 32.4756 29.5884 -13.7893 55.6862 -12.0377 +8938 4 8.07142 31.7837 29.8334 27.4303 -26.9633 6.13269 +8939 4 8.04212 33.3166 29.512 -13.0153 -27.2422 -1.65156 +8940 6 4.77821 31.644 22.4997 2.28771 28.4048 16.4959 +8941 4 5.27411 32.2412 23.0928 2.56389 -13.4484 -8.63656 +8942 4 4.12057 32.2584 22.1518 -1.39427 -10.0394 -7.16978 +8943 6 48.879 26.8662 2.67919 -5.86075 -60.7959 24.9619 +8944 4 49.7001 26.7095 3.23946 -26.2991 7.4186 -32.0291 +8945 4 48.3448 25.9902 2.75892 28.4546 51.6452 -6.88552 +8946 6 35.3626 23.261 21.6242 -2.7789 -2.57103 6.54281 +8947 4 36.2261 22.8974 21.81 4.94258 -15.6751 6.88864 +8948 4 35.5426 23.9136 20.9639 -1.02428 17.548 -23.8062 +8949 6 9.79934 37.7758 27.3048 16.52 16.637 17.9603 +8950 4 9.72643 38.6113 27.803 -16.1555 -8.36248 -12.7831 +8951 4 10.5885 37.4189 27.7206 -2.15823 -16.4776 -5.60851 +8952 6 6.95685 10.9812 25.9821 -25.178 -21.2877 -4.97438 +8953 4 6.33357 10.2528 25.7268 23.179 21.9129 0.503821 +8954 4 7.29095 10.6974 26.8328 9.60603 -1.481 14.6966 +8955 6 15.9965 34.4888 38.9273 -2.91878 -3.91161 19.3063 +8956 4 16.0374 33.5463 38.7461 4.95306 -0.665665 -16.4822 +8957 4 15.9715 34.4958 39.9054 -7.59103 5.72172 -22.2107 +8958 6 24.1167 17.3197 36.1615 15.3363 -47.5124 0.380375 +8959 4 24.7173 17.5753 36.8648 1.58194 5.49031 12.5141 +8960 4 24.1546 16.3101 36.2205 -9.7187 30.8811 -7.11116 +8961 6 29.9757 19.0472 5.63639 12.788 -31.6225 11.2379 +8962 4 30.1584 18.5328 6.46799 -12.7316 12.501 -21.5451 +8963 4 29.4206 19.7916 5.84051 -11.4929 16.6696 15.0892 +8964 6 41.2293 14.2018 25.873 -1.75888 28.9255 -23.3251 +8965 4 41.1078 15.0995 25.4693 3.83492 -22.0907 13.098 +8966 4 41.2654 14.3268 26.8215 3.7207 5.50516 9.94654 +8967 6 30.6006 17.7874 37.3562 -24.7598 46.8721 10.074 +8968 4 30.0173 18.4181 36.8416 23.2796 -25.9316 -1.25214 +8969 4 30.633 18.2764 38.2118 8.15578 -14.795 -8.30511 +8970 6 36.2662 35.7599 28.8527 -12.8707 -30.9202 21.2821 +8971 4 36.6718 34.9534 29.2396 -10.1595 12.442 -4.1956 +8972 4 37.0218 36.2801 28.6478 17.3511 22.2532 -11.5483 +8973 6 0.195836 37.8645 20.3851 -23.6217 6.21569 -13.9532 +8974 4 0.549498 37.2778 21.0637 4.94615 -2.95215 -2.70832 +8975 4 54.3862 37.4234 20.0075 16.4722 8.11718 6.90773 +8976 6 49.5165 39.5896 25.2714 -0.622408 -34.3922 32.9891 +8977 4 49.1772 39.7667 26.1925 10.9208 -1.11318 -32.3029 +8978 4 49.8261 38.6352 25.2806 -10.9036 35.658 1.81375 +8979 6 21.6574 10.1952 29.3538 -5.06277 -0.743802 10.2318 +8980 4 21.4664 11.1105 29.223 -3.01111 19.5458 -20.3057 +8981 4 21.662 10.2064 30.3052 9.73006 -17.7161 13.8831 +8982 6 36.4636 30.0567 0.119709 9.37859 61.6807 38.5429 +8983 4 36.3123 29.4684 41.3206 -1.21017 -23.1836 -37.505 +8984 4 36.9143 30.908 41.7057 -13.4567 -39.5067 4.20368 +8985 6 35.2344 23.3726 39.1433 31.8417 -88.9919 -51.9106 +8986 4 35.0278 23.5012 38.2069 -5.96056 -5.38998 8.96032 +8987 4 34.9909 24.127 39.538 -31.8308 96.9265 45.0865 +8988 6 25.4761 17.6258 38.7257 1.29934 8.28965 -16.1346 +8989 4 26.2031 17.0769 39.0234 13.7946 -6.33455 1.86524 +8990 4 25.7107 18.4933 39.0598 1.3782 7.33891 4.86011 +8991 6 32.6846 1.71002 15.3734 -11.6254 -20.3205 21.5399 +8992 4 32.9453 1.93093 16.3086 -8.96834 -8.53877 -20.2534 +8993 4 32.154 0.853232 15.3925 19.204 32.1949 4.36426 +8994 6 2.7574 26.2382 40.1716 -4.40087 -21.6692 -50.7652 +8995 4 2.38718 26.7949 40.8139 -8.13358 26.7101 38.7547 +8996 4 3.41358 25.6429 40.5298 13.0891 -5.49009 7.80053 +8997 6 25.4307 39.5752 6.64887 -26.4755 -1.32722 14.1102 +8998 4 25.8932 39.0809 7.30961 27.038 -6.17916 -3.25304 +8999 4 24.5458 39.4465 7.03066 -2.44587 12.932 -21.9634 +9000 6 3.88975 2.45855 21.1879 28.3389 -91.355 -25.6726 +9001 4 3.44478 1.54109 20.9736 25.4092 48.4753 9.01111 +9002 4 3.19228 2.99847 21.4284 -47.2055 43.8768 12.3888 +9003 6 19.4353 35.9908 6.17834 -1.98144 -11.1023 18.0698 +9004 4 18.7425 35.7628 6.83514 2.39623 12.5316 -16.1317 +9005 4 19.0828 36.5127 5.45195 -11.0597 11.4176 1.1294 +9006 6 53.664 10.8386 34.7899 -0.427116 -3.27611 41.7292 +9007 4 53.6105 10.6836 35.7561 -1.66612 -17.5448 -26.7849 +9008 4 53.9652 11.7272 34.8329 4.68725 29.9217 -18.2793 +9009 6 51.2799 14.0867 34.6651 -29.2798 -10.9719 -23.3019 +9010 4 50.6522 13.5411 34.1107 26.8684 18.9114 5.01949 +9011 4 50.9895 13.8814 35.5479 1.81167 -5.08277 17.6681 +9012 6 14.4338 40.0198 28.0288 -0.147098 23.5255 27.6002 +9013 4 13.7688 39.3521 27.8218 1.28331 -8.25373 7.75106 +9014 4 14.1948 40.5222 28.8704 -0.878391 -19.6822 -29.209 +9015 6 36.0552 40.8569 1.29319 48.4065 13.1893 15.2608 +9016 4 35.4421 41.0883 1.96787 -21.4185 -0.412662 13.5205 +9017 4 36.896 41.2683 1.66088 -27.5471 -12.7345 -18.5843 +9018 6 32.5846 21.8706 9.62772 14.4951 6.80277 0.680584 +9019 4 32.1936 21.3098 8.97285 -7.2875 -23.9506 -7.81502 +9020 4 32.858 22.6104 9.08324 0.955029 10.0343 1.40437 +9021 6 53.7602 11.4574 10.0748 -7.70253 -4.89045 -17.0247 +9022 4 54.6558 11.7035 10.3272 3.70339 -10.2166 -5.16833 +9023 4 53.8328 10.8374 9.31644 -2.27357 5.83713 13.9933 +9024 6 25.443 2.0669 35.0212 -16.7533 17.7231 -21.4763 +9025 4 25.6415 2.91576 34.5502 -7.64634 -16.7974 11.4347 +9026 4 24.4652 2.09352 35.1703 17.3945 -2.11295 -4.26167 +9027 6 38.4088 16.3775 27.0777 23.4896 -26.556 7.92078 +9028 4 38.4029 15.905 27.9411 -0.72651 18.7119 -5.4255 +9029 4 38.1233 17.2789 27.1678 -4.67214 15.3602 11.0072 +9030 6 11.9834 11.8283 38.0863 1.50515 -20.9897 -19.5245 +9031 4 12.337 12.445 38.7318 -5.05033 4.06408 7.46746 +9032 4 11.0493 11.6049 38.244 7.06215 11.5652 6.68382 +9033 6 21.1646 40.7247 25.8949 30.8575 -6.32012 -20.5276 +9034 4 20.7152 41.4784 25.5554 -14.4662 20.9939 -18.0031 +9035 4 20.8194 40.6451 26.758 -13.9443 -15.9826 36.5019 +9036 6 5.45737 31.2526 28.1092 12.1805 15.5126 -2.48606 +9037 4 4.77986 31.7446 27.6301 0.776808 -0.764161 -8.53258 +9038 4 6.21204 31.8695 28.2031 -7.61365 -6.18966 7.74582 +9039 6 38.5666 10.4345 26.6322 12.4833 -8.23035 1.5222 +9040 4 39.2815 10.9281 26.2104 -2.91177 1.8082 -0.00903947 +9041 4 39.0293 9.89744 27.2937 -7.88948 5.75886 -1.98766 +9042 6 34.5704 22.2441 5.77364 -5.35359 -6.12765 6.5276 +9043 4 33.6261 22.329 6.01336 10.9983 8.59631 1.2651 +9044 4 35.1361 22.6291 6.46875 -10.1328 -5.43064 -4.61746 +9045 6 19.508 23.4157 8.91293 -5.78488 4.73981 5.04963 +9046 4 19.7274 23.1974 9.83518 1.16663 -6.94775 -9.92836 +9047 4 19.9131 22.8043 8.29809 9.12387 -6.1547 2.91491 +9048 6 19.7424 39.1606 18.9462 6.36032 12.2479 8.14591 +9049 4 20.3561 39.0422 19.6872 -3.85164 -4.35394 -5.20149 +9050 4 19.0738 39.7495 19.3414 -1.06489 -8.07777 -11.9442 +9051 6 19.0057 16.6591 37.8853 37.3334 -16.7993 4.17439 +9052 4 18.1861 16.4809 37.4823 -32.8062 -2.38488 -19.1553 +9053 4 18.8146 17.2984 38.5514 -2.10283 15.4454 14.1988 +9054 6 46.1541 18.3125 34.4675 -16.9871 7.29415 15.254 +9055 4 46.1595 17.7325 33.7168 0.615393 -10.1859 -17.2384 +9056 4 45.2376 18.6499 34.5058 9.28079 -5.03019 -2.85447 +9057 6 37.6537 4.93165 10.635 20.1552 -8.04423 -16.7256 +9058 4 38.5399 5.21744 10.272 -26.6503 -7.30776 7.98139 +9059 4 37.1074 4.55852 9.88971 22.9932 21.6332 27.1334 +9060 6 51.9792 36.004 6.8478 30.791 3.18545 -0.726681 +9061 4 52.2413 36.7963 6.35992 -14.9215 -4.55469 -2.53046 +9062 4 52.8266 35.8818 7.33626 -22.3254 6.63746 5.40006 +9063 6 26.6741 12.3268 1.0034 -10.7024 -25.4666 -34.2692 +9064 4 26.4988 12.3574 1.94138 -4.81655 1.43394 14.8604 +9065 4 26.0954 11.585 0.663483 16.9242 17.5219 15.4646 +9066 6 51.3423 35.7724 13.5298 -0.266216 29.5034 10.6004 +9067 4 51.4043 36.4131 12.804 2.34884 -4.4098 -1.45811 +9068 4 51.4073 34.9167 13.1542 5.41074 -27.2154 -15.541 +9069 6 1.98873 3.64285 24.5869 25.9971 69.8048 -55.2188 +9070 4 1.65752 3.03018 25.1632 -30.3002 -46.9535 54.3289 +9071 4 1.71436 4.54846 24.8879 2.6309 -26.2008 -0.982747 +9072 6 33.5221 15.2795 16.4506 0.0536135 -15.838 -38.1617 +9073 4 33.6476 15.3964 15.4593 -8.63578 3.82522 35.1416 +9074 4 33.7341 16.1085 16.8736 8.85342 14.4801 4.37501 +9075 6 10.7227 26.5775 37.3442 -67.903 54.2831 -20.645 +9076 4 10.2191 27.0779 38.0369 14.5194 -13.2702 -3.80745 +9077 4 11.4784 26.2608 37.7268 68.0232 -30.094 41.6962 +9078 6 39.6271 8.38119 31.999 1.44949 -5.13238 35.1009 +9079 4 39.1996 8.85287 32.7464 5.61163 -5.5592 -21.3265 +9080 4 39.0885 8.45634 31.2221 -15.3514 9.3045 -12.0182 +9081 6 48.873 24.2439 11.5987 1.10357 -37.2725 -9.21005 +9082 4 49.1825 23.3167 11.4023 -5.65288 27.9965 8.32055 +9083 4 49.5986 24.6511 12.0826 3.19491 3.15896 -2.50749 +9084 6 15.8098 8.51994 22.5326 -12.5814 0.672941 2.19285 +9085 4 15.7588 8.52265 21.5683 10.3815 2.49136 4.36748 +9086 4 15.4206 9.36801 22.7863 6.5895 4.65597 -0.371293 +9087 6 16.9392 23.5364 7.95083 25.1749 21.5498 -34.0775 +9088 4 17.2079 23.9031 7.093 -25.8979 -5.01679 3.50755 +9089 4 17.8126 23.4623 8.29573 16.7216 -7.09478 32.6865 +9090 6 42.4825 26.8555 6.33102 0.60087 7.54144 -12.7632 +9091 4 41.764 27.4892 6.46083 9.75026 1.01062 3.5184 +9092 4 43.14 27.3488 5.78659 -9.42643 -3.33158 7.6404 +9093 6 36.8078 4.79995 30.0438 -4.74249 18.2042 -3.85385 +9094 4 36.952 4.89746 30.9922 3.10706 -1.8894 0.559973 +9095 4 36.294 4.02131 29.8808 -10.4691 -15.4659 3.71438 +9096 6 45.6128 11.6142 3.31163 15.5246 21.1623 13.6733 +9097 4 45.8972 10.701 3.31117 0.727629 -14.3179 7.30305 +9098 4 46.2501 12.0834 3.90994 -13.3278 -10.7206 -15.6492 +9099 6 24.8943 36.3842 21.2731 0.145584 -0.0155718 21.9832 +9100 4 24.5073 36.3627 22.1568 -5.92138 3.86098 -2.91089 +9101 4 25.79 36.6624 21.4916 7.30899 1.2523 -13.3669 +9102 6 31.8172 24.7218 2.44079 24.9542 32.077 -0.738567 +9103 4 31.5948 23.8911 2.82575 -7.26237 -24.1795 3.52598 +9104 4 32.7966 24.7848 2.51706 -20.2581 -1.29655 -5.98664 +9105 6 24.135 21.9795 37.225 -18.6422 57.7065 19.5247 +9106 4 24.1223 22.9841 37.1061 1.06209 -41.2434 9.50937 +9107 4 24.7129 21.6948 36.5371 13.1815 -12.7877 -24.1492 +9108 6 37.1979 11.5342 15.06 20.8972 -17.7328 -40.5152 +9109 4 38.0246 11.7972 15.4709 -1.33045 5.21986 19.7962 +9110 4 36.429 11.9138 15.4438 -18.178 22.6449 25.793 +9111 6 36.4751 20.3399 41.7845 -26.5497 -48.0551 41.2862 +9112 4 36.3228 19.4621 41.3748 1.60744 11.8178 -3.29004 +9113 4 36.9246 20.873 41.191 27.5593 28.4699 -43.2619 +9114 6 32.0497 37.9214 32.6612 -32.2386 -8.50634 -18.7459 +9115 4 32.4337 38.7163 32.9803 20.8647 20.5609 12.2985 +9116 4 31.3654 38.2694 32.0613 5.31663 -14.2519 5.69849 +9117 6 12.0395 39.928 22.5123 -26.9832 36.7812 23.3187 +9118 4 12.2839 40.8414 22.1926 -3.01474 -29.6796 4.86816 +9119 4 11.2932 40.0883 23.1662 29.524 -10.585 -25.0576 +9120 6 26.3406 1.33526 19.2893 15.6729 -20.8034 13.8388 +9121 4 26.8411 0.655996 19.8199 -14.5491 24.9752 -14.9066 +9122 4 26.8003 2.1813 19.3861 0.112049 0.00336314 -1.02908 +9123 6 5.91669 14.3164 5.69097 2.29729 -16.5161 -30.3395 +9124 4 6.30102 14.1024 4.7902 -6.32478 5.25084 23.5077 +9125 4 5.06552 13.8494 5.70115 7.33482 -6.30923 1.55114 +9126 6 13.3703 23.089 19.1627 -28.3895 15.3871 14.4757 +9127 4 14.1086 22.8122 18.6632 27.2898 -8.01563 -16.6587 +9128 4 13.6991 23.742 19.8005 3.67942 -13.964 0.879599 +9129 6 23.4058 15.0688 9.73621 -4.11719 1.06855 12.2005 +9130 4 22.5732 14.661 10.02 0.657405 4.9462 -7.25364 +9131 4 23.2196 15.7347 9.05868 -5.70535 0.38861 -5.0655 +9132 6 49.5812 13.8288 18.4474 0.101153 1.0527 41.008 +9133 4 48.8214 13.4814 17.9923 -8.96247 -7.71084 -15.1851 +9134 4 50.2052 14.1722 17.8367 10.7879 13.5653 -33.2962 +9135 6 41.7444 5.67096 41.8915 25.5819 0.859229 17.1787 +9136 4 42.5704 5.9364 0.475256 -21.6624 -6.74737 -14.5764 +9137 4 42.0361 4.9893 41.2645 -5.04703 6.59959 -2.77397 +9138 6 17.2492 35.5437 2.55512 -4.98919 17.2489 6.23124 +9139 4 18.1963 35.629 2.41282 7.59523 -3.20753 1.41995 +9140 4 16.9663 34.6563 2.38439 4.57262 -16.6324 -5.73806 +9141 6 49.6936 19.8647 40.242 36.1149 -8.05295 1.41344 +9142 4 49.24 19.0314 40.466 10.1916 2.45634 3.62304 +9143 4 50.6901 19.7225 40.3055 -34.6505 -2.12616 -4.55887 +9144 6 38.3055 5.83107 32.0437 -25.1209 3.13983 17.5072 +9145 4 37.8566 6.51058 32.5952 5.57321 -12.5864 -8.78808 +9146 4 39.2068 6.11217 32.0045 20.6085 6.27671 -1.8315 +9147 6 16.2656 6.85278 34.0134 13.6308 -7.44031 -0.955967 +9148 4 16.5278 6.7006 33.1016 -0.686465 1.61317 -6.98637 +9149 4 17.0706 6.57794 34.496 -11.7464 5.49098 9.02554 +9150 6 33.6779 18.1919 10.4599 39.833 -25.9405 -6.08719 +9151 4 34.2274 18.843 9.984 -7.48822 -11.4027 6.26591 +9152 4 34.2403 17.3374 10.5556 -30.6671 44.9369 -7.76686 +9153 6 38.8896 33.7563 36.7672 22.7659 10.9801 -36.8997 +9154 4 38.4264 33.5452 35.9055 8.66825 7.19978 21.2858 +9155 4 39.8358 34.0039 36.5278 -27.7603 -15.0244 3.77145 +9156 6 45.3747 13.0912 20.2115 -8.54575 18.1695 38.2532 +9157 4 45.1986 12.6554 19.3957 -4.2418 -14.8759 -23.2281 +9158 4 44.5273 13.1029 20.6991 7.89471 -4.73094 -13.0554 +9159 6 36.3919 32.2126 8.83938 1.15121 -2.28434 -1.4136 +9160 4 36.3207 31.3933 9.34391 1.93757 3.36082 7.91897 +9161 4 36.0586 32.9456 9.38554 -3.10773 -8.06217 -4.51958 +9162 6 7.93399 27.8164 6.18652 -8.84441 8.26416 -30.5327 +9163 4 8.20753 27.2416 6.88401 9.15323 -7.03573 14.7081 +9164 4 8.30192 28.6748 6.41842 -5.04409 0.971707 0.751098 +9165 6 14.2889 4.87494 33.6812 -48.074 -5.72289 -27.637 +9166 4 13.5426 5.15568 33.0467 38.2298 -5.02982 23.8683 +9167 4 14.8103 5.65434 33.8518 10.0815 16.0504 2.39638 +9168 6 12.247 8.64363 9.86387 9.5307 8.47707 -42.9656 +9169 4 12.7265 8.83196 10.6522 4.83417 -1.95201 32.3898 +9170 4 11.3733 8.28369 10.003 -7.27928 -7.56138 14.4849 +9171 6 29.7193 31.982 8.5339 -11.3757 5.45371 -22.6092 +9172 4 30.2272 31.7973 9.28681 18.5431 -1.21859 37.4341 +9173 4 29.7513 31.1489 8.05875 -9.95983 -0.182644 -6.87416 +9174 6 22.3912 10.8818 21.4749 22.6973 -30.3469 0.856054 +9175 4 21.7953 11.1177 20.7819 -19.5872 13.8984 -18.5017 +9176 4 22.3568 11.5583 22.1363 -13.7305 16.7548 8.89642 +9177 6 54.1825 27.5382 12.9949 16.0749 -34.873 29.2784 +9178 4 0.169556 27.5337 13.075 -9.84187 5.32432 -2.29215 +9179 4 53.8855 28.25 12.4714 -3.97587 36.1158 -26.3516 +9180 6 7.7322 13.8127 20.037 -51.4252 10.19 -38.2554 +9181 4 8.32211 14.101 20.6974 26.6579 16.8549 28.1402 +9182 4 7.28001 14.6396 19.6917 19.816 -24.9044 7.79538 +9183 6 19.8038 0.841082 24.7751 2.23798 25.7663 18.7115 +9184 4 19.2888 0.974936 25.5977 -1.44078 2.26272 -14.328 +9185 4 20.345 1.66892 24.688 -12.1486 -28.8133 2.35345 +9186 6 3.00622 10.0987 2.94957 -26.3714 23.4248 -9.90714 +9187 4 2.57802 10.9845 2.80681 8.85648 -28.8297 5.38 +9188 4 3.90714 10.2978 3.18407 20.8138 3.7803 5.2 +9189 6 15.8735 13.0135 24.0167 27.3456 -6.4848 -7.35342 +9190 4 15.0397 13.4574 24.067 -14.2007 12.8972 1.61729 +9191 4 16.3075 13.2711 24.8409 -0.511489 -7.63656 -0.0548578 +9192 6 17.0843 4.34635 26.9246 21.6007 -4.50946 14.2865 +9193 4 16.8972 4.2188 26.0046 2.50265 0.324122 -20.691 +9194 4 18.0611 4.2338 26.9976 -18.2314 5.96709 -0.11875 +9195 6 33.6189 39.4094 10.6341 -20.462 51.0085 -28.6484 +9196 4 33.9391 38.663 11.0702 20.9333 -51.253 8.17882 +9197 4 33.8334 39.409 9.67256 -1.15733 -4.02232 18.0774 +9198 6 36.2391 1.10544 13.1071 -14.4853 9.25302 -40.2412 +9199 4 35.5849 0.422507 13.2928 -0.138393 -8.38057 10.5121 +9200 4 36.8138 1.26142 13.8363 9.41155 -3.27129 23.8008 +9201 6 40.853 19.2974 5.10856 37.2457 -28.9827 71.4026 +9202 4 40.5429 19.587 4.3016 -40.6732 16.7295 -57.0845 +9203 4 40.1307 19.0416 5.7147 0.644924 10.2678 -10.4268 +9204 6 2.34714 37.5568 10.1845 35.9634 7.02123 17.8242 +9205 4 3.04769 37.1203 10.7322 -14.847 6.26565 -12.1612 +9206 4 1.86424 36.8893 9.71962 -14.8151 -24.6966 -11.8987 +9207 6 8.10127 29.0413 15.8656 35.302 -29.7249 12.8686 +9208 4 9.00843 28.6191 15.9508 -31.5464 15.4715 -14.0583 +9209 4 8.16404 29.7921 16.4466 -1.11054 13.1495 4.82257 +9210 6 47.3142 26.5199 12.5393 12.6514 34.6971 -22.5506 +9211 4 47.5805 27.2834 11.915 -17.373 -39.4708 28.4474 +9212 4 47.3752 25.7188 12.0092 -0.907674 -0.00416251 -5.94845 +9213 6 33.5917 17.5154 0.659811 -43.6991 -50.8046 22.4668 +9214 4 32.6165 17.4611 0.916402 33.9721 22.4374 -10.1482 +9215 4 33.8023 16.5556 0.790839 15.7196 25.0769 -8.55135 +9216 6 38.9785 15.6005 36.3846 -2.2974 -5.19358 -9.56289 +9217 4 39.1604 14.6481 36.4599 -0.972636 7.263 -3.41001 +9218 4 39.314 15.9159 35.5329 5.29716 -3.31476 -2.44888 +9219 6 34.8185 34.3512 9.36223 6.47638 -43.1481 -28.0847 +9220 4 35.4473 34.9875 9.0418 9.26483 22.2324 -9.2882 +9221 4 34.4241 34.6992 10.1221 -17.9819 29.7233 40.2724 +9222 6 44.963 2.56985 14.7807 31.4374 15.1132 5.36654 +9223 4 44.0324 2.49792 14.9225 -24.9873 -3.38313 6.1219 +9224 4 45.264 3.39221 15.2058 -8.16761 -2.00961 -7.57881 +9225 6 42.6004 38.2794 19.8329 35.0217 22.8895 -33.2683 +9226 4 42.7468 39.1886 19.4383 -9.39889 -30.5105 9.50416 +9227 4 43.174 37.7101 19.2395 -23.2435 10.9907 19.5876 +9228 6 18.6884 26.768 30.2631 -44.5574 -6.69712 -17.565 +9229 4 18.1049 26.7773 29.4546 19.8507 -1.43152 25.0232 +9230 4 19.5658 26.9377 29.9555 24.8572 5.14496 -8.76909 +9231 6 38.8622 37.7231 16.4658 -22.8479 4.5656 13.1257 +9232 4 38.7902 36.7734 16.2818 1.44729 8.74588 -1.32739 +9233 4 39.7766 37.9619 16.5567 26.2519 -3.67716 3.06508 +9234 6 49.2941 9.82087 12.5338 42.2108 35.2088 45.7943 +9235 4 48.9089 9.29765 11.888 -36.0338 -29.0733 -40.4243 +9236 4 48.6148 10.195 13.1058 -6.01968 0.395602 -5.44143 +9237 6 43.2224 7.37144 19.82 -8.13737 3.26926 23.5272 +9238 4 42.5007 7.77471 20.3735 21.5488 -7.79487 -11.5807 +9239 4 44.0862 7.49788 20.2643 -6.92785 0.102081 -4.68832 +9240 6 36.344 38.7219 4.42923 6.60518 -8.27287 -3.54737 +9241 4 36.8681 39.515 4.62823 -9.591 -1.38231 4.53716 +9242 4 35.4251 38.8858 4.67742 1.90858 4.69501 2.45497 +9243 6 27.7906 17.7903 15.1063 3.75124 -7.8529 -14.6222 +9244 4 27.6041 16.8818 14.7764 0.112743 20.8749 5.00331 +9245 4 27.89 17.7299 16.0573 -1.67078 -3.69001 6.73869 +9246 6 18.0934 3.7697 37.3166 -37.4896 -7.94699 -19.9181 +9247 4 18.6099 3.0373 36.9676 7.8944 1.98274 4.30106 +9248 4 18.6508 4.23334 37.9126 25.9725 10.5984 22.5053 +9249 6 7.70643 11.5866 6.5218 3.89219 -35.3855 26.5153 +9250 4 7.81247 12.3986 6.99593 -0.830342 19.7116 4.35361 +9251 4 7.69429 11.7375 5.59555 -1.18048 8.56411 -33.1609 +9252 6 31.493 14.3493 18.0362 -8.33789 -14.4781 24.6772 +9253 4 32.1359 14.6991 17.4236 11.1505 2.18599 -11.6706 +9254 4 31.9992 13.8221 18.6877 -1.72215 8.99473 -5.41338 +9255 6 50.3257 30.4119 8.91981 13.6638 2.66477 0.921327 +9256 4 49.6699 30.7962 8.33415 -6.09837 5.9585 -1.44957 +9257 4 50.0726 29.5063 9.09532 -3.6785 -2.74239 1.52637 +9258 6 42.1666 10.1001 12.7665 27.8846 0.568566 -7.78474 +9259 4 41.2574 9.89168 12.6212 -25.0269 -7.71108 -1.23548 +9260 4 42.2044 10.927 13.2385 -4.76175 6.29789 8.61568 +9261 6 37.7726 3.10257 32.5651 17.7286 -33.908 -11.3576 +9262 4 38.1655 3.96622 32.6549 -5.80606 19.6252 0.391082 +9263 4 36.8286 3.11418 32.7073 -14.5698 15.7581 5.48125 +9264 6 35.7529 13.1025 19.269 15.6222 -22.7979 5.95892 +9265 4 36.108 13.8438 19.7616 3.89933 6.86159 4.70877 +9266 4 36.3275 12.3403 19.5267 -16.9537 12.3267 -5.61016 +9267 6 45.5307 4.12701 21.4866 3.53751 -14.4086 10.8893 +9268 4 45.552 4.15257 20.5178 1.20389 1.85135 1.62688 +9269 4 45.7304 3.20168 21.7391 -1.66454 15.9633 -13.005 +9270 6 16.8818 1.84763 31.4809 -38.7514 34.7723 -17.791 +9271 4 16.1373 2.3559 31.0688 16.7124 -32.2776 -3.52377 +9272 4 16.9707 2.38347 32.2636 22.4894 -8.71684 18.7287 +9273 6 14.088 4.88632 23.5804 12.6338 -46.5447 -4.7054 +9274 4 13.8705 5.7909 23.7155 -14.7558 31.001 11.1078 +9275 4 13.7332 4.31383 24.2952 -4.17517 18.1368 -8.36436 +9276 6 38.3179 33.7515 12.3711 -25.6361 -5.15185 -28.4625 +9277 4 38.1256 32.9508 11.8227 6.04426 17.9062 13.2724 +9278 4 39.1779 33.654 12.756 21.0695 -5.21903 12.1581 +9279 6 35.6902 3.04562 37.6746 -3.39904 8.35156 -7.25132 +9280 4 35.0929 2.54933 38.2324 -5.1037 -10.0227 3.00486 +9281 4 35.8394 3.86187 38.1597 5.81883 9.20211 1.39187 +9282 6 31.3375 37.3986 35.3773 -3.71028 -11.6357 31.0668 +9283 4 32.2621 37.6229 35.4422 12.7398 8.80293 9.59752 +9284 4 31.1956 37.5429 34.4696 -8.56261 0.879722 -41.7472 +9285 6 52.0699 11.7425 14.0188 13.7235 -2.71131 -30.9774 +9286 4 51.8967 11.0942 13.2788 12.7756 18.36 20.3091 +9287 4 52.777 12.3878 13.7226 -29.9657 -23.6346 9.26958 +9288 6 26.3494 3.44143 41.0133 25.155 -37.875 16.6614 +9289 4 25.5593 3.94137 41.1232 -17.1598 23.2709 -17.7277 +9290 4 26.8278 3.58917 40.1822 -8.59815 12.7626 -4.44352 +9291 6 24.371 34.9599 11.1571 26.4033 32.6711 -2.50587 +9292 4 24.3639 34.5741 12.011 0.42503 -6.32387 38.1824 +9293 4 23.9976 34.2869 10.6415 -25.866 -31.4028 -29.8537 +9294 6 32.0031 7.59722 31.2247 -0.72006 7.33901 18.8157 +9295 4 32.1508 7.36357 30.327 0.345644 0.817488 -27.7554 +9296 4 31.6126 8.48818 31.2118 -2.13527 -8.40442 2.30992 +9297 6 28.7291 2.6069 0.424694 -24.9548 -1.7826 -18.2237 +9298 4 29.2265 2.34055 41.548 2.55638 3.32464 9.52498 +9299 4 27.7798 2.59721 0.142899 25.7986 3.33204 9.63582 +9300 6 42.1267 19.2107 9.86358 19.9254 -1.00598 31.807 +9301 4 42.7282 19.2504 10.675 -28.0191 -3.63038 -32.4782 +9302 4 41.4654 18.506 9.99331 2.41107 5.70909 -2.24499 +9303 6 33.0117 27.0899 8.33041 6.96541 -9.8522 -22.9567 +9304 4 33.8754 26.9804 7.88875 -4.89246 2.6856 6.68054 +9305 4 33.1889 27.2976 9.23992 7.88062 7.04275 14.0068 +9306 6 4.17016 8.31297 19.162 0.312608 -23.727 -31.8356 +9307 4 4.57057 7.90515 18.3575 7.98956 13.418 22.158 +9308 4 3.24181 8.25888 18.9046 -6.31749 7.79174 9.16769 +9309 6 20.797 29.1851 37.0682 -78.8245 -16.0462 -5.4556 +9310 4 20.936 28.2326 36.9784 16.4861 -0.723813 3.66436 +9311 4 21.5674 29.6886 37.0761 54.0195 18.5923 4.39527 +9312 6 13.113 4.99943 10.9253 0.843453 12.9862 -7.21248 +9313 4 13.3812 5.91092 11.1622 0.48683 -16.0572 0.936043 +9314 4 12.7752 5.03128 10.0238 -4.21215 6.55392 -0.64752 +9315 6 37.5015 18.1018 32.5195 21.2703 25.6519 14.9603 +9316 4 38.1786 18.7738 32.2234 -25.3038 -17.5123 8.13315 +9317 4 37.1867 18.4103 33.3985 6.70568 -0.056708 -13.7279 +9318 6 17.7491 33.2689 30.7387 4.64458 14.8517 -20.1826 +9319 4 17.8421 33.9996 30.1068 1.39741 -2.79987 6.34018 +9320 4 18.5541 33.2627 31.2599 6.50121 5.74528 2.59283 +9321 6 23.1871 32.777 9.90494 7.13269 10.4795 -4.3903 +9322 4 23.4604 31.94 10.2921 1.41378 -5.3263 0.807867 +9323 4 22.2339 32.7251 9.74224 0.938735 -0.283076 -0.953242 +9324 6 14.8916 9.36878 34.2544 -3.17606 -9.25219 -4.09189 +9325 4 15.4257 8.57154 34.1751 4.23415 -4.52565 -0.814207 +9326 4 15.1936 9.94604 33.5417 3.33837 13.7034 4.88209 +9327 6 31.123 39.3556 38.5725 10.4581 -15.7875 9.507 +9328 4 31.6408 38.6334 39.0195 -17.0405 19.4438 -10.5616 +9329 4 30.3963 38.9123 38.1137 2.26745 0.847431 0.999129 +9330 6 5.28935 34.441 28.2777 -1.85934 -10.7383 -20.8922 +9331 4 5.27738 35.3973 28.3959 -1.64374 -0.931958 4.82044 +9332 4 5.15855 34.3195 27.3212 3.56171 0.206479 13.9304 +9333 6 30.3161 21.6889 14.1169 -2.08187 28.5408 26.4102 +9334 4 30.4824 20.7856 14.3415 3.20532 -20.0191 -7.60805 +9335 4 30.3589 21.8902 13.1869 1.55029 -10.1196 -17.5522 +9336 6 23.85 39.0046 28.2977 69.4329 26.2515 4.57453 +9337 4 23.9916 39.6084 27.5499 -13.57 2.08121 2.63988 +9338 4 23.036 38.5875 28.2612 -60.5143 -23.8938 -11.8576 +9339 6 9.59742 13.5396 16.4589 33.261 19.9292 -8.86772 +9340 4 8.78625 13.0496 16.3926 -14.9619 -4.96746 -5.567 +9341 4 9.78335 13.9533 15.5888 -9.09133 -14.4247 9.50074 +9342 6 25.9705 6.17968 15.7985 42.799 -23.1477 28.9675 +9343 4 26.019 6.01901 14.8637 -2.75181 4.35539 -17.3872 +9344 4 26.7603 5.64791 16.135 -36.9143 25.7793 -10.0513 +9345 6 15.9952 33.6108 22.5498 -1.32684 21.179 0.174096 +9346 4 16.0845 34.132 21.7265 -5.08009 -17.3545 9.33233 +9347 4 16.0452 32.6693 22.2946 2.44519 21.8582 -2.86748 +9348 6 40.6954 13.5457 12.1293 -5.68603 3.79069 10.9638 +9349 4 40.3939 13.0592 11.3555 -1.07855 -14.0058 -3.54454 +9350 4 41.0539 12.9031 12.7626 -3.06611 3.62129 -5.67307 +9351 6 35.5822 40.2773 31.6862 -1.2862 -13.706 14.6905 +9352 4 36.0451 40.9783 31.2154 -1.32327 -4.34646 -14.1397 +9353 4 35.653 39.3915 31.2603 0.648621 22.1552 -3.29488 +9354 6 19.3539 17.5757 17.8527 24.8545 64.4629 -5.36553 +9355 4 19.9703 18.4106 17.9379 -31.776 -45.1138 0.798127 +9356 4 18.7059 17.8424 17.1823 2.41282 -7.28307 3.58563 +9357 6 7.95249 28.0742 10.7793 26.3782 25.043 4.49745 +9358 4 8.50313 28.8396 11.0908 -15.1612 -19.5627 1.83511 +9359 4 7.20779 28.4792 10.322 -5.34026 -2.34355 -4.06419 +9360 6 32.1473 39.5951 16.6478 -17.9563 1.55165 -8.91142 +9361 4 31.6569 40.3908 16.3404 14.2892 -12.9666 6.03874 +9362 4 31.5266 38.8716 16.4637 6.06753 4.48602 8.64925 +9363 6 35.7883 2.63292 18.1275 9.48574 -34.9606 14.0071 +9364 4 34.8666 2.32593 18.1793 13.7366 6.70894 -2.41967 +9365 4 35.7792 3.51083 17.8116 -6.62646 29.9084 -15.3578 +9366 6 14.9404 39.9496 36.887 -3.95865 -34.2615 35.0372 +9367 4 15.4649 39.4425 36.2826 11.0028 -6.45738 -16.6057 +9368 4 15.0284 40.8419 36.6608 5.56286 51.7396 -15.8162 +9369 6 18.3052 32.4025 11.469 7.68428 8.43447 19.219 +9370 4 18.6311 32.5236 12.4045 -8.3236 -1.07971 -30.5152 +9371 4 17.8613 33.2392 11.223 7.02035 -14.738 0.639166 +9372 6 14.6021 10.381 5.00501 12.904 -5.64335 9.41677 +9373 4 13.6938 10.4305 4.69945 -10.3065 0.63937 1.1744 +9374 4 14.613 10.0418 5.92181 -1.23128 6.20644 -15.3767 +9375 6 2.02771 14.3355 39.1727 -5.84559 30.0988 4.34298 +9376 4 2.70173 15.0418 39.0898 -4.78946 -14.8923 5.30178 +9377 4 1.28797 14.7602 39.6738 10.0694 -17.377 -15.1558 +9378 6 7.58332 14.1556 32.4652 3.8824 27.7869 10.7592 +9379 4 6.9433 13.665 32.9756 -4.43494 -6.18284 1.69377 +9380 4 7.54129 15.0698 32.8492 6.23928 -24.1467 -15.6449 +9381 6 6.15722 23.1341 37.6504 -34.5618 -50.1938 -2.0692 +9382 4 6.56488 23.96 37.7745 13.4151 41.4847 -0.267706 +9383 4 5.38195 23.2242 37.0516 20.9526 5.02196 8.70483 +9384 6 37.2952 22.537 4.44472 51.3933 75.9823 3.75371 +9385 4 36.5074 22.1342 4.18978 -47.7056 -22.8011 -17.3868 +9386 4 37.221 23.5361 4.21623 -3.53185 -51.7458 12.1203 +9387 6 47.1368 31.0168 5.89375 -14.3926 17.1884 -69.1718 +9388 4 46.9718 30.7968 6.77028 -10.6218 -7.91998 56.0799 +9389 4 46.2684 31.351 5.53353 23.0456 -16.9797 4.17914 +9390 6 54.8109 25.5937 34.9376 16.0179 27.3393 -6.0446 +9391 4 54.0726 25.4665 35.5517 -1.08617 7.29827 -2.61058 +9392 4 0.161491 26.54 35.0366 -21.9365 -36.0956 3.57937 +9393 6 37.1499 2.07739 4.80452 -1.94348 22.0087 -45.3652 +9394 4 36.668 2.89852 4.54683 5.06511 -19.4283 11.9563 +9395 4 37.1062 1.96831 5.73813 -4.74438 -1.19387 27.2393 +9396 6 22.5142 28.609 8.91066 14.7838 -0.767913 33.3492 +9397 4 22.9803 28.3541 9.73828 -15.565 12.7605 -7.61321 +9398 4 22.8168 27.9481 8.31925 3.93055 -13.9923 -25.0246 +9399 6 8.64284 27.1533 24.5627 -30.3364 66.7798 9.61681 +9400 4 7.68564 27.0552 24.6389 4.16714 -15.7471 -5.05425 +9401 4 9.10482 26.3676 24.4825 22.9633 -64.4218 -6.53839 +9402 6 1.14841 23.7276 2.43845 3.37143 2.75553 -28.3576 +9403 4 1.24451 23.8913 1.47114 -2.40676 3.6179 20.3541 +9404 4 0.297784 23.2877 2.48462 -2.13531 -2.42607 6.29474 +9405 6 54.3749 30.2279 27.0351 -1.87188 5.01086 -25.6864 +9406 4 54.247 29.4439 26.4851 0.283672 1.58093 2.67322 +9407 4 54.589 30.9178 26.3677 -1.31459 -2.18642 16.2549 +9408 6 0.382292 8.43516 23.9819 16.8945 -11.9539 9.7221 +9409 4 1.32445 8.60369 24.1565 -2.20413 -11.2301 -8.89161 +9410 4 54.9553 8.73001 24.7921 -9.77823 11.7559 2.768 +9411 6 16.9131 28.5848 33.3683 -2.23593 -25.3201 -21.0962 +9412 4 17.3654 28.7863 34.1955 9.02781 -2.88055 -0.915496 +9413 4 17.3951 27.8627 32.8656 -13.2947 27.9561 26.4245 +9414 6 33.6945 30.8881 0.140848 11.5734 5.16226 7.65985 +9415 4 34.5903 30.4955 0.196618 -6.50407 7.83028 -3.90982 +9416 4 33.2725 30.4522 41.313 0.902851 -8.5209 -4.03004 +9417 6 16.2572 21.5133 34.1618 -1.32279 -12.2579 -0.0768877 +9418 4 15.8666 20.7686 33.6578 14.5936 10.7995 5.0381 +9419 4 16.7742 21.1109 34.8905 -13.5083 8.43335 -11.1581 +9420 6 0.208862 17.804 35.7536 -14.601 -29.9007 -2.72034 +9421 4 54.2286 17.807 35.5323 33.4083 9.0609 14.8615 +9422 4 0.362977 16.9429 36.1939 -0.60553 13.4006 -6.21859 +9423 6 16.8205 12.2987 0.018055 22.2965 10.2312 29.8095 +9424 4 17.2696 12.8062 0.753963 -11.4311 -8.71934 -28.0399 +9425 4 16.617 11.4478 0.422257 -11.1364 1.3302 -4.58262 +9426 6 8.24969 9.53941 36.253 -15.0171 13.8578 -6.15226 +9427 4 7.92627 8.96163 36.9484 -10.0154 -4.61382 -0.313479 +9428 4 7.46687 9.9886 35.83 14.4541 -3.15884 14.1629 +9429 6 48.5699 26.7153 39.8372 -6.05787 -6.72914 15.0837 +9430 4 48.3449 26.8926 38.9385 -16.4424 3.29077 -18.6566 +9431 4 49.4571 27.0352 39.8842 23.4859 3.73228 5.76721 +9432 6 35.4844 1.07048 23.1169 11.4549 30.8088 37.1655 +9433 4 36.0158 1.76714 22.6808 -9.17201 -14.7916 0.90361 +9434 4 35.6328 1.27141 24.1103 0.373025 -19.0496 -44.6811 +9435 6 20.2784 30.6315 19.3752 23.9103 -21.6662 15.3888 +9436 4 20.3116 31.0532 20.259 -5.42732 -3.95571 -8.57186 +9437 4 20.9344 29.8759 19.4191 -22.0709 25.9102 -5.54449 +9438 6 44.3706 15.9499 1.58551 5.68582 14.4456 12.9619 +9439 4 44.3685 15.5676 2.49167 2.87795 14.7015 -16.764 +9440 4 44.6274 16.9163 1.6094 -6.5628 -31.3198 6.45039 +9441 6 53.8881 34.4681 10.5864 -33.0496 11.7448 -26.9592 +9442 4 54.422 34.2751 11.3149 32.4161 -9.35278 40.7994 +9443 4 54.2788 35.2396 10.1584 -0.0979649 -6.0993 2.73708 +9444 6 46.1388 32.8516 33.5211 5.22207 -15.0187 3.22626 +9445 4 45.9452 33.6327 33.0044 -1.75723 11.2428 -3.91525 +9446 4 47.0422 32.5752 33.2841 -5.1447 4.42718 0.252344 +9447 6 42.1248 21.9061 24.225 29.3467 -8.59285 14.1471 +9448 4 43.0897 21.6191 24.2618 -39.2895 4.06832 7.69751 +9449 4 41.7308 21.6944 25.1042 13.707 1.91177 -18.5137 +9450 6 8.13464 3.90485 11.6471 19.3767 -1.70453 -18.8264 +9451 4 7.33962 4.19894 12.0861 -8.05938 -6.79837 10.6821 +9452 4 8.35918 3.01511 11.9412 -4.68297 1.80025 9.46807 +9453 6 19.6422 41.6776 9.83213 -10.6455 12.1827 13.5714 +9454 4 18.8651 41.1405 9.66265 4.99962 -3.76564 -7.41899 +9455 4 19.3487 0.264237 10.6212 9.02518 -11.5641 -14.6522 +9456 6 42.3073 8.42404 31.6799 28.9247 6.2763 -10.2166 +9457 4 41.4386 8.38933 32.0551 -18.7028 2.48038 0.978172 +9458 4 42.5266 9.37939 31.5704 -3.99861 -19.3235 1.7837 +9459 6 26.9144 16.155 25.3557 3.37886 4.46922 -29.1574 +9460 4 26.8932 15.8089 24.4276 -4.09623 14.1183 21.5023 +9461 4 26.5944 15.4425 25.8888 -2.2842 -17.5105 15.3426 +9462 6 48.2339 6.48607 12.6213 -2.32796 -4.32122 -9.13051 +9463 4 48.9884 6.29985 12.0375 -6.36801 1.93824 2.64233 +9464 4 47.4521 6.15437 12.1363 8.14441 0.739204 7.03502 +9465 6 53.4551 41.5313 30.6545 -6.55363 -20.9747 -16.7061 +9466 4 53.9707 41.8328 29.895 1.38615 3.54438 2.31965 +9467 4 53.5938 0.199493 31.3858 11.9182 14.0856 15.8016 +9468 6 47.0766 22.4304 31.8083 3.49024 11.2606 -9.33253 +9469 4 47.8957 22.458 31.249 -27.0486 7.80914 13.6686 +9470 4 46.5597 23.2507 31.6033 14.3992 -20.3875 6.89099 +9471 6 19.5103 5.43818 15.252 80.4346 7.77941 -36.259 +9472 4 19.9845 4.58151 15.2093 -6.94904 10.3389 3.32724 +9473 4 18.6939 5.26573 15.6196 -64.0069 -9.45641 27.6942 +9474 6 14.6723 30.2358 33.3977 29.3194 14.0021 -15.573 +9475 4 15.2147 30.9127 32.9173 -16.9191 -15.4944 5.99358 +9476 4 15.2716 29.4658 33.3729 -9.39086 7.05787 2.01807 +9477 6 28.44 24.2314 10.4028 3.15123 -12.4056 -9.54268 +9478 4 29.226 24.4262 10.8786 32.4584 2.85658 2.79411 +9479 4 27.8296 24.5485 11.0342 -36.3144 6.15546 12.0187 +9480 6 5.27118 14.4387 24.4945 35.1445 25.2092 -0.0633509 +9481 4 4.43594 14.1516 24.7736 -48.8682 -19.2375 4.52664 +9482 4 5.4685 14.0235 23.6561 -3.04719 -11.4521 -9.99341 +9483 6 26.3524 19.2908 19.1818 20.1263 -20.0506 -24.4735 +9484 4 26.6388 20.1349 19.5116 -1.98461 18.5008 5.62334 +9485 4 27.0961 18.9592 18.5977 -26.1102 9.18548 27.2368 +9486 6 28.5758 7.44193 13.1857 16.8206 36.5977 2.40675 +9487 4 28.4276 6.5743 12.8854 -8.83608 -34.241 -6.14436 +9488 4 29.1296 7.84613 12.4994 -7.23682 2.38597 3.89632 +9489 6 5.36882 27.1473 37.046 11.8823 -4.88323 19.1587 +9490 4 6.08575 26.9595 37.7076 -19.1456 -1.45009 -21.6041 +9491 4 5.36685 28.0942 36.8598 5.86896 -0.355799 -4.60773 +9492 6 53.1378 13.4025 16.0996 34.2435 -3.86055 5.06914 +9493 4 54.0829 13.0966 15.9504 -32.0077 5.91706 2.7318 +9494 4 52.5847 12.6783 16.4422 5.4814 -0.344951 -11.4066 +9495 6 45.452 1.01889 24.6154 3.31322 11.7394 9.54943 +9496 4 44.8157 0.989703 23.8982 -3.33354 -4.25493 -1.52857 +9497 4 44.9019 0.844105 25.4008 9.82267 -2.51687 -6.81685 +9498 6 50.1641 2.37547 13.9256 -5.79196 7.9049 4.59273 +9499 4 50.7992 2.78767 13.3238 -3.84891 -0.754592 0.637936 +9500 4 49.4746 3.0334 14.0873 2.34893 4.7321 -2.13859 +9501 6 19.5803 31.0161 39.1628 -18.0613 -25.9328 -11.5794 +9502 4 19.7424 30.2951 38.4816 -0.347779 24.7736 22.083 +9503 4 18.6224 30.9377 39.4182 28.2801 4.19594 -11.375 +9504 6 19.2561 14.7051 10.8744 35.9018 -50.5273 5.13524 +9505 4 20.0412 14.097 10.5737 -45.0165 49.548 5.48727 +9506 4 18.7602 14.0269 11.3662 -4.16951 16.5755 -2.6658 +9507 6 4.45594 39.5485 20.1375 -7.26247 21.8372 28.3356 +9508 4 3.95576 40.4005 20.2782 15.6699 -22.2203 -5.74536 +9509 4 4.87483 39.3065 21.0019 -15.4768 4.14169 -24.4646 +9510 6 29.0152 13.3442 23.91 8.01267 35.4951 15.4816 +9511 4 28.7225 12.4574 23.7464 -4.82052 -12.6612 5.31893 +9512 4 28.8407 13.5397 24.8723 9.679 -4.85246 -32.6651 +9513 6 17.068 2.76349 17.6602 17.5731 -10.7754 -19.6116 +9514 4 16.9152 3.43747 16.9733 0.569879 -2.90947 3.06519 +9515 4 17.8166 2.20316 17.3149 -21.6663 12.1671 7.12297 +9516 6 43.4725 18.0406 17.7144 -1.44781 -24.3706 15.3127 +9517 4 43.4291 17.0524 17.7495 6.1749 24.1268 -14.107 +9518 4 43.576 18.2305 18.6573 0.474252 7.4982 -2.94392 +9519 6 25.7765 40.7491 1.25834 -5.13784 -8.67992 -41.8469 +9520 4 26.3241 41.1434 1.92597 2.9618 17.1891 5.50682 +9521 4 25.7331 41.3641 0.469204 -4.81559 -13.5206 29.0343 +9522 6 0.465549 22.8917 6.22214 -2.55797 -7.94984 -3.9446 +9523 4 0.971697 22.1453 5.8424 -8.20264 3.34524 4.91565 +9524 4 1.09943 23.372 6.75946 4.60597 5.6548 -4.31438 +9525 6 26.241 35.011 18.6432 -1.36099 17.7753 -9.20742 +9526 4 25.9471 35.9461 18.6768 6.76043 -15.7179 -8.96745 +9527 4 25.6107 34.5957 19.2286 4.79325 -10.2415 3.05652 +9528 6 16.134 31.8742 7.55305 63.3701 -24.5537 -22.1036 +9529 4 16.96 31.3344 7.22221 -43.8871 18.402 28.1533 +9530 4 16.2567 32.6659 7.02685 -6.92396 6.43503 -6.66113 +9531 6 22.9365 16.8424 28.5556 -11.8911 28.7995 -6.03551 +9532 4 23.1131 16.1224 27.957 -2.92592 -13.6094 -7.1053 +9533 4 22.1672 17.3806 28.2048 22.5292 -24.3034 15.5849 +9534 6 48.8154 29.3426 32.1508 17.6607 -5.63259 25.101 +9535 4 47.9338 29.1776 31.8283 -15.752 -0.354552 -3.67809 +9536 4 48.876 28.9209 33.0523 -3.3832 13.4569 -22.7771 +9537 6 13.1275 24.861 5.55911 -24.9858 12.0714 -24.023 +9538 4 12.9095 24.1076 4.98414 3.68764 2.77663 3.09454 +9539 4 12.4428 25.5491 5.3163 19.4298 -17.0083 16.84 +9540 6 10.97 20.7168 15.838 25.2219 -21.2413 -18.4662 +9541 4 10.9273 20.4774 14.8836 -9.78471 10.8905 20.232 +9542 4 11.8407 20.3068 16.0784 -25.4832 11.5027 -0.03881 +9543 6 13.8668 18.3675 6.9377 -17.1805 34.1284 -15.5183 +9544 4 13.9861 19.3268 7.07801 0.95534 -8.68107 -9.41428 +9545 4 14.2312 17.9937 7.71618 14.696 -22.4056 21.3209 +9546 6 13.8328 12.9436 30.6366 23.8936 8.4875 1.93436 +9547 4 14.0561 12.5213 29.7889 -15.7862 -10.4805 9.2002 +9548 4 13.0857 12.5134 31.0734 -5.46762 -5.09599 -12.1481 +9549 6 17.1276 6.33232 31.2677 66.6528 76.8842 26.6004 +9550 4 16.7194 7.19542 31.0916 2.25558 -4.54354 -1.53399 +9551 4 16.4872 5.75051 31.0533 -74.7845 -70.3194 -26.0669 +9552 6 7.63688 23.4278 20.549 2.87884 3.81634 -6.68902 +9553 4 7.34623 23.1229 19.6666 2.94756 -0.449201 10.6329 +9554 4 8.04096 24.3016 20.3852 -3.87648 -11.4978 -1.95405 +9555 6 15.5875 36.6622 25.6317 44.8659 35.0544 -6.16252 +9556 4 16.5723 36.6215 25.7443 -25.3852 -14.6967 7.558 +9557 4 15.5456 37.5452 25.2115 -8.92727 -11.7797 -1.50769 +9558 6 0.738994 10.4213 22.1809 -27.1543 -36.2471 -13.1925 +9559 4 0.031346 10.3136 21.4752 22.4259 7.4169 21.1377 +9560 4 0.614162 9.62536 22.7539 0.837437 23.266 -16.3015 +9561 6 33.4753 17.3986 33.5966 50.0322 34.9653 -25.691 +9562 4 33.729 18.3684 33.3861 -23.79 -42.9591 12.1009 +9563 4 34.1104 16.8695 33.0603 -9.99519 5.32569 13.787 +9564 6 21.6594 19.0069 20.7632 22.9673 -17.6764 -6.78691 +9565 4 22.3468 19.6741 20.9606 -3.94962 -13.1079 -1.95693 +9566 4 22.1476 18.14 20.6003 -16.6978 33.0759 6.74927 +9567 6 41.7633 20.003 16.8748 -11.326 -1.31128 -8.84591 +9568 4 42.2034 19.1563 16.9874 6.48398 -7.2756 0.328325 +9569 4 41.4682 20.0367 15.9399 8.87316 5.12137 10.7952 +9570 6 12.0358 14.9766 17.6999 -26.21 -7.2152 -26.0517 +9571 4 11.2991 14.5498 17.1995 11.2858 13.8526 14.1879 +9572 4 12.4764 14.2447 18.105 9.10187 -13.3837 13.9354 +9573 6 23.0147 11.4211 40.7142 -19.9953 11.3897 74.5259 +9574 4 22.9359 12.2968 41.1901 4.60696 -23.5555 -21.1396 +9575 4 23.3157 11.5565 39.857 19.7433 14.0142 -51.5111 +9576 6 21.0056 28.3023 24.5803 -69.1041 85.2373 -40.9106 +9577 4 20.265 28.1264 25.1705 5.37048 -3.26467 3.49678 +9578 4 21.6928 27.7549 24.7451 59.1792 -66.0576 27.8401 +9579 6 19.39 13.7159 31.9239 29.4118 -13.0288 15.1298 +9580 4 18.7661 13.9847 31.2678 -13.3276 3.02657 -9.68553 +9581 4 18.8827 13.5849 32.728 -3.24577 4.6437 7.00982 +9582 6 21.5915 2.84466 24.7134 0.208747 24.5944 -29.04 +9583 4 21.6872 3.18692 23.7998 -4.92058 -5.74628 13.5023 +9584 4 22.4885 2.58061 24.905 3.18231 -12.543 15.1704 +9585 6 11.3458 29.9955 18.8336 12.03 22.8495 18.6886 +9586 4 10.5716 30.5896 18.8018 6.29595 -15.7791 -4.99952 +9587 4 11.9743 30.476 19.4324 -17.0963 -23.9187 -22.0967 +9588 6 14.6495 22.3648 8.3568 42.8177 1.00499 7.23029 +9589 4 14.0031 23.0587 8.53935 2.83958 6.20927 5.13977 +9590 4 15.5993 22.7606 8.33857 -60.0645 -13.0658 0.526795 +9591 6 43.9468 23.6541 17.2812 -2.43742 26.8438 -12.7514 +9592 4 44.7651 23.2701 16.9945 19.1668 -3.91001 -9.18188 +9593 4 43.5028 22.9 17.6346 -11.2125 -8.13016 15.2757 +9594 6 28.0047 25.4978 27.5091 9.49546 -35.4414 -7.32855 +9595 4 27.536 26.3032 27.53 -22.6173 33.7003 2.08289 +9596 4 28.9082 25.7508 27.3241 10.2254 5.98924 0.98151 +9597 6 19.1021 26.8113 33.1456 6.96794 1.44941 -44.6281 +9598 4 19.0009 26.3889 32.2316 6.61058 22.4795 36.193 +9599 4 19.4537 27.7357 32.9996 -8.5054 -25.835 6.12407 +9600 6 6.37601 19.3499 5.67113 -3.07724 -15.511 8.20386 +9601 4 6.68786 20.0294 5.07731 7.18653 8.65774 -7.7972 +9602 4 5.56195 19.7092 6.03854 -2.87224 2.62267 4.46635 +9603 6 37.49 28.403 9.68405 -10.2736 -31.6176 -26.4717 +9604 4 37.8518 27.9475 10.4351 5.1765 10.0485 19.5132 +9605 4 37.3493 27.6251 9.09625 -2.69325 25.3221 7.01666 +9606 6 17.6998 27.0953 11.7898 -36.7906 -34.4972 13.5582 +9607 4 17.0141 26.488 11.3694 25.6316 27.0728 3.78529 +9608 4 17.4298 27.07 12.7376 6.94557 14.4563 -18.9236 +9609 6 12.8888 1.93962 24.1529 -50.3802 38.9184 -15.728 +9610 4 12.0235 2.45928 24.1313 32.0413 -19.6529 -17.3906 +9611 4 12.9222 1.7892 25.0724 13.055 -19.4335 33.1456 +9612 6 27.8476 37.1183 33.3015 17.2618 -5.56645 -20.6455 +9613 4 27.8725 37.7306 32.5366 -3.66202 -8.07766 15.1749 +9614 4 28.4268 36.3488 33.0405 -13.8477 22.6944 8.61763 +9615 6 18.6736 12.3707 6.31908 6.91225 -31.4632 27.4828 +9616 4 18.6995 11.385 6.25383 -9.67628 20.7874 -2.26223 +9617 4 18.5836 12.6888 5.4344 -4.12511 6.2973 -26.1687 +9618 6 10.1784 29.305 24.7735 -9.10204 -23.9111 21.4033 +9619 4 10.6991 28.9855 25.5395 2.35147 16.2142 -6.30056 +9620 4 9.48939 28.598 24.7147 15.6456 22.7499 -9.47694 +9621 6 7.25796 3.28933 16.2737 -3.06701 21.6066 -7.53298 +9622 4 7.8017 4.02386 16.6541 -5.18893 -18.6288 5.77884 +9623 4 6.83195 2.7267 16.9458 19.6595 6.39335 -0.783342 +9624 6 32.1965 37.5589 1.11244 17.7564 -13.393 -49.4834 +9625 4 31.8113 36.9118 1.6863 -14.8068 -2.94474 23.9511 +9626 4 32.3136 38.4192 1.49585 -8.3749 16.0852 25.1081 +9627 6 10.4319 10.1504 6.4166 -7.63199 8.14139 10.6713 +9628 4 9.50403 10.3698 6.52583 -9.38347 6.87647 -8.77798 +9629 4 10.8186 10.5343 7.22249 5.92406 -9.68277 -8.25616 +9630 6 16.1813 23.2506 37.3799 25.1097 11.6639 -4.85114 +9631 4 16.5396 23.4181 38.2693 -7.5274 5.30939 -3.10176 +9632 4 16.7237 23.8262 36.781 -18.6662 -9.83464 11.0165 +9633 6 24.0859 14.3313 36.5421 -9.86516 7.30801 -0.382215 +9634 4 25.0278 14.1902 36.5644 12.4097 -8.07045 3.76472 +9635 4 23.7255 13.9571 37.3615 2.98939 6.5027 1.55174 +9636 6 27.4763 18.5532 28.7891 -13.5271 -4.91773 7.22809 +9637 4 27.279 18.1935 29.6763 -0.617381 3.48163 -16.8994 +9638 4 26.6639 18.4733 28.2428 3.34183 3.33207 10.806 +9639 6 51.5601 10.4909 1.56577 -57.9967 -14.5533 -18.7957 +9640 4 50.8004 9.99697 1.98849 19.2905 21.9947 -18.6033 +9641 4 52.233 10.462 2.20044 35.6887 -2.31897 35.1783 +9642 6 31.1159 39.6224 27.5035 10.1927 26.9633 6.19817 +9643 4 30.6636 39.3812 28.2975 -12.6206 -22.2416 8.82104 +9644 4 31.2642 40.5609 27.7597 6.49383 -23.2522 -24.0775 +9645 6 6.91312 35.9708 14.3252 -31.0555 -15.8542 22.3873 +9646 4 7.60399 36.2341 13.7609 26.7748 16.1612 -20.4248 +9647 4 7.14109 35.0698 14.5861 -2.88708 -0.858877 1.78829 +9648 6 45.5543 7.568 29.1737 -25.5302 -4.16762 -2.13202 +9649 4 44.8976 7.53234 28.4293 19.2773 0.699039 20.3251 +9650 4 45.0852 7.16669 29.9393 6.23602 2.26061 -10.7804 +9651 6 31.3622 20.562 31.6184 9.65463 4.63597 0.319717 +9652 4 31.8498 21.4034 31.7895 1.14978 -23.5084 -11.6884 +9653 4 31.8627 19.9392 31.0494 0.180852 16.2895 10.8054 +9654 6 43.0328 31.1512 10.3804 -22.1718 15.2565 33.5805 +9655 4 42.075 30.8844 10.4741 26.7443 4.92622 -3.29861 +9656 4 43.2631 31.5811 11.2548 -4.68507 -19.1463 -31.4268 +9657 6 50.935 25.5526 12.6381 -53.0362 -11.2381 37.5759 +9658 4 50.8444 26.3707 12.1889 6.26198 32.0523 -21.5557 +9659 4 51.7606 25.1556 12.4927 46.8244 -9.35474 -8.90879 +9660 6 29.329 2.97736 3.64421 22.5456 -43.1143 -6.52899 +9661 4 29.5843 3.84773 3.82541 15.3974 46.6652 11.4603 +9662 4 28.3975 3.01514 3.57252 -35.3193 1.84796 -10.7817 +9663 6 53.9306 32.0952 20.3602 -26.044 3.42844 6.98601 +9664 4 54.8587 32.2554 20.2589 13.6369 -3.90514 -8.57062 +9665 4 53.586 31.7345 19.5218 3.48091 2.50952 8.05406 +9666 6 41.7156 29.5544 6.48768 19.5894 27.0766 -19.1548 +9667 4 40.8143 29.536 6.19581 -21.1406 0.0261655 0.681639 +9668 4 42.121 30.2839 5.93213 -7.9284 -21.0777 21.5612 +9669 6 37.8354 24.5725 39.3073 -0.786614 -2.83003 -8.48557 +9670 4 37.3057 24.1981 38.5867 -0.305281 2.91934 11.1175 +9671 4 37.4479 24.2715 40.1417 -1.64355 1.86967 -5.36783 +9672 6 46.558 27.5785 23.289 -39.9634 -64.6481 11.0379 +9673 4 46.4646 27.3918 24.2576 6.74558 16.0433 -18.2165 +9674 4 45.9199 26.8188 22.9475 37.5572 46.869 6.09964 +9675 6 9.22773 27.2022 8.33468 -36.26 12.7871 28.7267 +9676 4 8.91275 27.6129 9.1801 5.62558 -9.89589 -23.2096 +9677 4 10.1414 27.0456 8.46037 35.2783 -3.07459 2.5747 +9678 6 36.0491 34.1608 13.9867 7.26402 -14.0442 8.68546 +9679 4 35.9913 33.1738 14.0461 -7.39622 22.1346 -4.41017 +9680 4 36.7548 34.3393 13.3524 -0.0889916 -4.95725 -2.25698 +9681 6 51.6742 14.4867 12.321 25.1613 25.5512 -24.4042 +9682 4 52.0989 14.4284 11.4335 -6.19684 -3.38259 22.4379 +9683 4 51.9807 15.3554 12.6493 -12.3863 -19.4348 1.31199 +9684 6 15.2583 19.6409 32.4144 29.0083 -20.2623 -33.8133 +9685 4 15.2558 19.2688 31.4922 3.04968 7.12699 22.6875 +9686 4 14.3622 19.8256 32.5802 -41.1763 4.86179 8.56209 +9687 6 27.6812 24.6569 38.3606 -19.0318 -31.8029 -32.3422 +9688 4 27.9736 25.1472 39.0974 14.6808 26.4307 29.745 +9689 4 28.3717 24.6185 37.6939 9.13491 6.22605 4.36089 +9690 6 37.5205 9.26898 13.6241 11.458 -4.07639 -2.41324 +9691 4 37.986 8.73412 14.2818 -4.17908 -1.66932 4.91722 +9692 4 37.422 10.1332 14.0472 -5.80925 -1.58022 -1.38856 +9693 6 20.8962 33.2419 26.2614 5.37543 12.855 -2.41316 +9694 4 21.3204 33.4412 27.1125 -5.30181 -3.15861 -4.46659 +9695 4 20.9369 32.3076 26.1263 8.87353 -20.0108 1.20924 +9696 6 6.59104 13.9455 35.2329 -26.8274 -4.60486 4.58094 +9697 4 6.38745 12.9897 35.2457 11.7642 5.99643 -3.17645 +9698 4 7.53507 14.0926 35.2395 12.5421 -8.77428 2.26249 +9699 6 10.0726 7.48467 6.8792 2.12641 6.95589 -11.9404 +9700 4 9.21804 7.15917 6.5645 -4.80657 -1.75614 5.47812 +9701 4 10.1222 8.42177 6.5916 5.16955 -15.159 7.51812 +9702 6 31.1977 5.95154 11.4339 24.7603 28.3677 15.6689 +9703 4 31.4296 6.16733 12.4018 -4.97657 -8.97631 -41.3224 +9704 4 31.9131 6.32779 10.8565 -11.9651 -11.6794 24.5691 +9705 6 12.1328 3.85103 35.2933 -10.0815 -12.0493 27.5499 +9706 4 12.7851 4.21657 34.7189 20.4312 8.87509 -12.0205 +9707 4 12.5123 3.89786 36.1903 -2.36263 6.36147 -16.6701 +9708 6 5.35168 6.07805 27.6549 3.96089 -18.0524 46.6648 +9709 4 5.01336 6.85569 28.0965 2.16186 8.49085 15.9688 +9710 4 5.1377 6.25223 26.7855 -7.5711 11.2001 -66.4514 +9711 6 13.1382 33.574 1.68419 20.6109 34.6607 2.95503 +9712 4 12.5953 33.0967 1.0817 -13.6453 -8.09858 -18.4215 +9713 4 13.3822 34.4502 1.26439 -11.0211 -27.5174 16.1165 +9714 6 44.6427 10.3996 29.0359 8.91116 23.4714 -13.18 +9715 4 44.4953 9.45294 29.0952 0.434286 -4.87704 -7.20081 +9716 4 44.1618 10.7755 28.2587 -0.00111917 -13.6507 16.636 +9717 6 9.15295 24.5944 6.37753 4.35763 15.0755 22.3214 +9718 4 8.87327 24.2546 5.53613 0.42871 5.14079 -20.2862 +9719 4 9.64462 25.4438 6.24707 -3.48643 -17.4971 -5.55606 +9720 6 52.5676 27.2719 21.6547 -2.39965 -30.061 -11.5856 +9721 4 52.5233 26.307 21.7841 0.332471 11.3908 13.792 +9722 4 52.7558 27.2791 20.7178 5.02488 16.4903 -8.77251 +9723 6 7.3066 16.9604 33.5537 -1.04195 2.49046 -7.43677 +9724 4 7.33543 17.7138 32.943 1.81348 -0.803559 0.920864 +9725 4 6.38938 16.6816 33.595 -7.62852 -0.129201 -7.36731 +9726 6 43.922 25.2186 7.97522 -0.776236 -10.551 19.3716 +9727 4 43.2647 24.8119 8.58447 10.2741 2.86697 -16.6436 +9728 4 43.4353 25.9147 7.53069 -5.46224 6.25576 -5.43654 +9729 6 2.0869 27.1165 13.6049 -6.62274 17.6596 -9.16822 +9730 4 2.19606 26.2295 13.9488 0.235583 -10.4047 3.43352 +9731 4 2.56841 27.1544 12.7597 2.10867 -4.70259 8.20201 +9732 6 37.3318 18.2771 2.1863 -11.4974 3.81579 3.71073 +9733 4 37.5653 17.6745 1.47223 -1.7687 -9.97531 1.83125 +9734 4 36.746 18.9091 1.7765 -5.93566 5.03593 -3.95155 +9735 6 24.9999 10.057 0.434977 -12.0635 -2.74649 0.799886 +9736 4 24.3308 10.4048 41.7106 3.78591 -9.33137 12.164 +9737 4 24.5954 9.37599 1.02184 5.69483 17.6459 -16.041 +ITEM: TIMESTEP +10 +ITEM: NUMBER OF ATOMS +9737 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 5.4990000000000002e+01 +0.0000000000000000e+00 4.1909999999999997e+01 +0.0000000000000000e+00 4.1909999999999997e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 9.97007 5.59928 0.0158605 6.82717 25.1566 0.173859 +2 2 9.62356 5.56404 40.5109 2.42388 15.8202 -17.9785 +3 2 8.17494 6.05177 40.4142 55.7411 37.9916 -4.02595 +4 3 7.24177 5.30408 40.552 -31.6102 -16.3698 1.50252 +5 4 9.18703 5.26911 0.576869 6.09491 -0.0281501 2.37507 +6 4 10.258 6.55078 0.333037 -13.6694 -25.1619 -9.93433 +7 4 10.7495 5.00053 0.227298 4.73684 -5.2578 1.97242 +8 4 10.3453 6.24708 39.9044 -16.4644 -11.4072 20.4818 +9 2 9.76873 4.13927 39.9675 -11.4588 -40.6165 34.779 +10 2 9.50273 3.78744 38.4932 15.666 28.6261 8.68394 +11 5 10.1133 2.12508 38.0108 0.295651 13.5297 3.11239 +12 2 9.21855 1.10832 39.2168 14.7368 7.58368 -1.20954 +13 4 9.08721 3.4839 40.6484 10.5431 15.7462 -21.5186 +14 4 10.7894 3.80905 40.2705 3.27862 -1.66199 -9.78219 +15 4 9.96352 4.6291 37.9056 6.4614 -19.967 -0.497951 +16 4 8.45197 3.92389 38.2658 -20.9649 -8.28542 -1.62155 +17 4 9.45855 1.42591 40.2577 0.123087 -4.74543 -3.47868 +18 4 9.48787 0.0601841 39.0477 5.23249 -11.9374 1.58081 +19 4 8.1518 1.18086 39.043 -21.148 5.31153 -2.14239 +20 1 8.09229 7.41048 40.3029 -14.2332 10.7223 -5.89196 +21 2 6.79937 8.10304 40.1889 5.24089 -19.8495 27.4218 +22 2 6.18195 7.49232 38.9365 0.114954 6.75236 -38.7125 +23 3 6.7427 7.67352 37.8124 -12.8129 -5.94191 21.2876 +24 4 8.91546 8.03754 40.1502 -4.33809 -15.705 2.93584 +25 4 6.18636 7.83053 41.1247 8.71228 4.86543 -21.2479 +26 2 7.05427 9.64124 40.1755 -39.1485 4.05492 14.7867 +27 2 5.78354 10.5475 40.1236 1.30256 17.7056 10.1762 +28 2 4.88546 10.5193 38.8862 -3.79578 -25.0164 33.8013 +29 3 5.09523 11.2746 37.9701 4.75276 20.2207 -26.2166 +30 1 3.8145 9.69296 38.9578 -10.6259 3.8922 -22.0733 +31 4 7.59986 9.93872 39.279 22.1314 0.316188 -7.87442 +32 4 7.59095 9.90263 41.1476 2.09094 2.02455 -19.3111 +33 4 6.10317 11.6308 40.2015 3.5236 -15.0099 -9.27626 +34 4 5.16114 10.4864 41.0336 -3.30627 -13.4665 3.57605 +35 4 3.54863 9.07856 39.7488 8.69916 3.95403 -0.745788 +36 4 3.18874 9.68238 38.1158 12.5738 1.24403 17.0425 +37 1 5.02604 6.79083 39.0278 7.4524 -0.797845 -45.9123 +38 2 4.17847 6.29332 37.9221 -3.7942 -15.2224 -3.95324 +39 2 2.69747 6.67222 38.2029 32.4064 16.6491 21.8024 +40 3 2.47317 7.27763 39.2627 -13.9875 -5.03172 -5.20453 +41 4 4.49693 6.75941 39.8611 -16.5463 3.77927 46.4214 +42 4 4.45927 6.7815 36.9606 1.68834 7.22657 1.16434 +43 2 4.32357 4.73766 37.6872 -14.444 16.6417 -7.09057 +44 2 3.62009 3.87951 38.7772 14.6644 -34.8859 1.43809 +45 2 5.79989 4.34797 37.5209 14.6689 -37.6664 -23.8861 +46 2 3.73665 2.34984 38.4383 -15.0607 27.3941 -9.62179 +47 4 3.8042 4.58537 36.6865 5.44811 -8.07725 9.84866 +48 4 2.54132 4.09064 38.8487 -7.82462 7.38089 1.0406 +49 4 4.05844 4.00808 39.8052 -1.99007 7.91776 -7.51683 +50 4 6.34139 4.39198 38.494 2.7915 9.59572 -3.8015 +51 4 6.26587 4.94741 36.6895 -0.816692 -0.0793993 15.4171 +52 4 5.96503 3.2496 37.1567 -11.5696 29.092 9.48874 +53 4 3.39623 2.18998 37.357 4.41378 -5.40883 18.8177 +54 4 3.12239 1.76276 39.1489 -5.35757 -4.6989 -2.16583 +55 4 4.76682 2.00075 38.5743 10.6291 -5.64517 -2.52342 +56 1 1.71265 6.3536 37.3575 -33.5913 -12.5481 -9.77554 +57 2 0.284755 6.62158 37.6816 12.6554 33.7668 -4.20076 +58 2 54.3822 5.43344 37.3699 -27.7691 3.87457 8.29319 +59 3 54.7838 4.49252 36.6867 3.01204 -3.04336 -3.37779 +60 4 1.82497 5.72672 36.5372 4.10411 3.68048 5.38879 +61 4 0.194803 6.88576 38.7694 2.48378 -12.979 2.09758 +62 2 54.7189 7.90551 36.9466 -7.72609 -12.13 5.61678 +63 2 0.656639 9.069 36.6919 -2.01357 8.03554 13.9604 +64 2 1.52683 9.2194 35.5966 7.55435 5.75852 -14.6577 +65 2 0.515029 10.1503 37.577 28.0972 23.5099 -14.6501 +66 2 2.25128 10.4257 35.3726 -4.96866 -39.5758 -10.6477 +67 2 1.27413 11.3326 37.3973 2.53894 16.486 1.64204 +68 2 2.1477 11.4375 36.2812 10.2448 65.1187 39.3263 +69 4 53.8018 8.25583 37.5371 13.1335 -2.90056 -11.9634 +70 4 54.3208 7.62968 35.9579 -2.73912 -6.0948 -8.85904 +71 4 1.62786 8.40831 34.848 -1.08621 1.70246 3.68663 +72 4 54.8519 10.113 38.4282 -15.3846 -1.92761 17.9785 +73 4 2.932 10.5406 34.5118 -0.192368 -3.19302 0.526177 +74 4 1.1987 12.2443 38.1226 0.692592 -32.2473 -20.0357 +75 4 2.79857 12.4271 36.2097 -23.9561 -41.0367 -3.09354 +76 1 53.0712 5.5328 37.7893 -5.57771 32.7805 23.2413 +77 2 51.973 4.62909 37.5111 5.69369 -27.8287 -42.174 +78 2 50.7933 5.44178 36.9635 6.83138 2.9595 14.8019 +79 3 50.2601 6.28483 37.7029 -2.00888 -3.43203 -15.9694 +80 4 52.7232 6.34215 38.4237 19.8206 -30.3225 -23.0649 +81 4 52.294 3.8899 36.6472 -5.7065 17.91 27.0613 +82 2 51.558 3.79481 38.7755 -4.51595 7.33433 1.21121 +83 2 50.3828 2.83682 38.5018 -9.13901 -44.4412 -29.5986 +84 2 52.8166 3.00155 39.2294 -15.7012 -7.04664 11.9409 +85 4 51.1774 4.47766 39.5861 12.1653 -0.853429 -2.8896 +86 4 50.5215 2.15128 37.5875 8.57056 17.9281 16.1392 +87 4 49.4053 3.30815 38.2892 0.50336 12.9055 3.57196 +88 4 50.1645 2.10956 39.3273 7.20165 10.7054 2.61524 +89 4 53.3305 3.56036 40.0335 2.85201 1.25263 3.90533 +90 4 53.556 2.88446 38.4204 4.77396 -6.45058 -3.13498 +91 4 52.5519 1.98529 39.6413 5.25091 8.27159 -2.68354 +92 1 50.4114 5.20625 35.6841 -20.1476 8.87025 -3.50293 +93 2 49.1688 5.73971 35.0966 -28.9774 8.99335 -1.66554 +94 2 48.0726 4.67952 35.3573 13.5632 -27.7837 -20.7653 +95 3 48.2724 3.51151 34.9309 -12.9152 20.0019 12.3092 +96 4 50.758 4.377 35.1895 1.67728 -2.63512 -1.50997 +97 4 48.8371 6.69602 35.5973 10.748 -7.18216 5.66994 +98 2 49.2038 6.04752 33.5367 10.0422 21.5226 29.5984 +99 2 47.9776 6.84135 32.9981 5.60977 17.6728 -19.5296 +100 2 48.06 7.31101 31.4919 41.3779 8.51018 8.58065 +101 2 48.2223 6.22581 30.3803 10.2277 10.7815 -8.37061 +102 1 48.1882 6.76889 29.0124 -44.0668 -20.3552 -6.98541 +103 4 49.2392 5.11894 32.9842 10.5057 -23.1259 -12.3022 +104 4 50.1653 6.62923 33.3927 -11.345 -5.02104 -10.4632 +105 4 47.825 7.77207 33.6051 2.48464 -5.23088 2.05035 +106 4 47.0343 6.2773 33.0942 -1.95432 -7.79908 6.21428 +107 4 48.9189 8.07819 31.4105 -13.7973 -19.6161 -0.159439 +108 4 47.1832 7.92091 31.2683 -17.7289 5.61577 -2.96622 +109 4 47.3306 5.536 30.4593 16.0468 -5.76301 1.4082 +110 4 49.2642 5.74618 30.4425 -24.8663 -4.45667 9.08666 +111 4 48.9827 7.28362 28.7526 29.3958 17.558 -6.10605 +112 4 47.3901 7.43056 28.8463 17.4375 -26.0151 1.0329 +113 4 48.1308 5.99149 28.2967 -4.23626 26.2635 18.8845 +114 1 46.923 5.03715 35.9679 -17.5656 23.7329 15.0201 +115 2 45.6707 4.26397 36.0383 7.41887 0.1342 36.2715 +116 2 44.9083 4.3955 34.7419 -9.99807 18.7078 -56.0122 +117 3 45.3082 5.1515 33.8118 -11.5681 -21.3087 27.1246 +118 4 46.8218 5.98238 36.4144 8.23522 -16.4135 -11.8728 +119 4 45.8989 3.17264 36.1884 2.80321 2.94058 -5.13324 +120 2 44.7401 4.70263 37.2808 -1.60464 -36.3649 -20.2774 +121 3 44.4616 6.07663 37.208 27.8602 32.4116 16.0792 +122 2 45.244 4.25605 38.6868 21.6281 49.2853 -20.5016 +123 4 43.7497 4.17807 37.1099 13.0537 7.54308 5.65065 +124 4 45.2592 6.57873 37.5303 -28.9412 -17.1189 -11.5145 +125 4 45.9129 5.11546 39.1089 -19.7485 -23.953 -1.10378 +126 4 45.8752 3.36487 38.6536 3.71139 -12.8851 -1.61893 +127 4 44.3595 4.03827 39.3021 -3.33201 1.23649 16.0156 +128 1 43.7613 3.66416 34.5997 13.2589 -16.0433 44.4251 +129 2 42.7828 3.62815 33.5465 18.9204 -1.21878 -42.6601 +130 2 41.7763 4.78741 33.7016 8.26701 -3.22526 52.4496 +131 3 41.2647 5.35582 32.7525 -2.05798 3.57411 -28.7638 +132 4 43.4932 3.04471 35.4154 4.99312 14.665 -20.8764 +133 4 43.36 3.79542 32.5266 -17.2288 -0.741434 30.8189 +134 2 42.0901 2.2209 33.4572 -3.06831 -30.079 -8.91003 +135 2 42.9343 0.899345 33.7586 6.86735 -2.69949 -8.81151 +136 2 42.2038 41.463 33.3849 1.50493 16.9918 14.9247 +137 2 44.2499 0.864187 32.9361 47.2855 12.5868 41.6398 +138 4 41.5678 2.05281 32.481 6.79941 12.0418 -2.16148 +139 4 41.2531 2.16469 34.1657 -6.29243 10.0771 8.19014 +140 4 43.198 0.869694 34.8519 -1.4112 0.953999 -4.44245 +141 4 42.8702 40.5903 33.6002 -4.10478 0.398246 -9.68788 +142 4 41.7896 41.4589 32.3582 7.27854 -3.68783 -7.38435 +143 4 41.3262 41.3063 34.0224 -6.75638 1.39507 6.42691 +144 4 44.0947 0.829251 31.8728 -5.75954 4.64229 -28.5029 +145 4 44.9396 41.8855 33.1737 -20.9549 12.1515 -1.19165 +146 4 44.9309 1.76601 33.2059 -22.5069 -20.3291 -10.4095 +147 1 41.5145 5.2236 34.9901 10.2672 4.08625 -51.0356 +148 2 40.6676 6.35891 35.268 -24.1778 -10.7223 -7.79527 +149 2 41.3691 7.72376 35.0974 2.95483 13.7574 -3.11119 +150 3 40.6975 8.75349 34.8431 -2.15612 -12.5202 3.44484 +151 4 41.8176 4.64617 35.7553 2.04542 -7.36824 24.1106 +152 4 39.8621 6.3427 34.4551 10.5786 9.41727 7.44594 +153 2 39.8405 6.1283 36.5756 19.8539 -2.67173 26.8296 +154 3 40.7601 5.89106 37.6735 -0.128972 20.3018 -14.678 +155 2 38.9248 4.89402 36.5497 -24.3083 -6.19306 -11.8519 +156 4 39.228 7.01129 36.8511 -0.372961 8.24506 -6.20484 +157 4 41.1549 6.75425 37.8536 -4.13097 -9.7211 -3.01543 +158 4 38.1722 4.94482 35.71 1.05658 9.14576 13.4136 +159 4 38.3953 4.71355 37.5213 -1.28546 9.2328 -6.30902 +160 4 39.3771 3.92967 36.3433 23.1336 -11.0543 -1.24287 +161 1 42.7302 7.8059 35.1562 3.49276 1.34371 4.78693 +162 2 43.5269 8.99303 34.9539 -8.19772 -21.7996 13.9087 +163 2 44.4646 9.39471 36.0778 41.0762 49.5413 -62.5687 +164 3 45.3993 10.2183 35.7654 -29.643 -36.0587 21.7786 +165 4 43.357 7.05719 35.4614 -7.13629 -15.5308 5.06399 +166 4 44.0803 8.92821 34.0189 14.2015 -9.60403 -10.8131 +167 4 42.9032 9.83742 34.7399 -16.6431 23.0824 1.78637 +168 1 44.28 8.95267 37.3076 -5.41717 -6.01048 56.4016 +169 2 45.1954 9.30059 38.3934 14.0544 9.09198 9.45122 +170 2 46.5736 8.71838 38.034 -4.40481 25.0392 4.24124 +171 3 46.7239 7.52665 37.7592 -2.06685 -10.8071 -7.31186 +172 4 43.4369 8.46722 37.66 -0.808029 1.80219 -13.797 +173 4 45.2932 10.4319 38.4595 -5.35026 -12.3633 -15.6489 +174 2 44.7775 8.83735 39.8303 19.1756 -23.9015 -7.23155 +175 2 45.4882 9.63492 40.9425 5.24315 -15.5914 27.8506 +176 2 45.0424 11.1143 41.0465 6.36216 -11.291 -10.339 +177 2 45.9827 11.9035 0.041605 38.3537 -2.96327 34.4916 +178 1 45.5586 13.2421 0.396463 -0.785075 15.3756 28.9492 +179 4 44.9912 7.72238 39.9953 -4.79728 17.8629 -7.78445 +180 4 43.7049 8.96345 39.9422 -22.2512 0.44531 4.07292 +181 4 46.5908 9.56019 40.8161 0.364544 3.82252 -6.52459 +182 4 45.3434 9.10335 0.0599805 -5.24686 13.9981 -23.7842 +183 4 44.0132 11.1324 41.4274 -10.2695 3.39123 6.70816 +184 4 44.9981 11.6023 40.04 1.8072 0.416607 6.15726 +185 4 47.0442 11.9436 41.5493 -17.6115 6.73335 -5.13538 +186 4 46.1824 11.4052 1.05233 -16.0491 -0.928483 -18.7699 +187 4 45.666 13.9003 41.5429 -6.15709 2.25656 -0.794581 +188 4 46.187 13.6261 1.17403 -31.6799 -14.737 -27.4943 +189 4 44.5482 13.2658 0.707841 33.0262 6.71149 -7.77427 +190 1 47.5786 9.61919 37.9975 -0.262725 18.6124 2.96873 +191 2 48.9681 9.33197 37.6414 -20.2336 1.72319 -17.1083 +192 2 49.7588 9.70622 38.88 39.5209 -76.7499 14.8721 +193 3 49.6145 10.763 39.4317 -9.44289 38.5374 13.5639 +194 4 47.4009 10.6083 38.3248 7.77058 -18.5649 -8.96176 +195 4 49.0172 8.23798 37.4216 9.46753 0.884559 0.506936 +196 2 49.3323 10.1282 36.3163 3.6714 0.82331 31.2642 +197 3 48.3563 9.85046 35.3281 -8.1318 -4.77519 -4.71381 +198 2 50.6865 9.72677 35.695 -19.0046 0.743943 -11.7808 +199 4 49.2557 11.2077 36.6021 8.67648 2.0602 -8.11811 +200 4 47.5419 10.2678 35.5977 -2.15846 0.170791 -0.678761 +201 4 50.8563 10.2671 34.7416 2.67544 8.24981 1.47477 +202 4 50.7066 8.66813 35.3754 2.1247 -7.47433 7.78713 +203 4 51.5309 9.954 36.3541 9.43429 -0.352141 7.40173 +204 1 50.5004 8.65755 39.48 -48.513 49.986 -45.0014 +205 2 51.0618 8.74392 40.7907 20.8089 -26.4742 28.5407 +206 2 52.5708 8.35776 40.7906 -32.7343 -31.0986 -30.3541 +207 3 52.9098 7.36002 40.1044 19.6712 31.5314 12.7437 +208 4 50.5882 7.8265 38.898 12.8881 -18.9119 10.2231 +209 4 50.9863 9.78895 41.141 -1.46865 8.60563 4.12328 +210 2 50.3037 7.79505 41.8358 -16.725 28.936 13.8764 +211 2 50.252 6.27959 41.4904 27.2589 15.6434 -4.64867 +212 2 48.8609 8.35011 0.225019 8.85004 14.588 -17.6069 +213 2 49.3953 5.42325 0.497373 -18.8945 7.05888 30.2377 +214 4 50.814 7.95159 0.918621 8.35305 -8.94958 -7.30269 +215 4 51.3186 5.93048 41.4774 -6.84536 -5.23847 5.64953 +216 4 49.9408 6.1608 40.4387 -8.33431 -3.05112 -5.55566 +217 4 48.166 7.96072 41.344 -1.46 7.63128 5.53427 +218 4 48.8165 9.51657 0.246026 0.467008 -30.2893 -0.065267 +219 4 48.5175 7.97406 1.21641 -4.07563 3.27994 -1.48455 +220 4 48.2983 5.58085 0.347667 5.50609 -0.627552 -5.84055 +221 4 49.5344 5.58322 1.60624 7.63779 5.91871 -13.4594 +222 4 49.5909 4.36583 0.361303 3.03099 -20.7712 -9.01704 +223 1 53.3669 9.15083 41.5136 39.5682 14.7354 5.79836 +224 2 54.8443 9.26777 41.6313 -32.7918 27.0996 3.53674 +225 2 0.372396 8.2907 0.722751 15.0567 -33.4937 20.6099 +226 3 54.8856 8.2259 1.87915 11.4238 -3.26125 -20.3466 +227 4 52.9167 9.73978 0.288924 -10.841 14.2188 11.5997 +228 4 0.25416 9.07559 40.636 9.98484 -5.7038 -17.1316 +229 2 0.351513 10.7152 0.19938 0.985642 14.1538 -10.6635 +230 3 54.4575 11.7797 41.7528 -11.3464 -18.6066 -9.73211 +231 2 1.66903 11.1049 41.4122 7.34382 -22.4378 -10.8926 +232 4 0.4803 10.8256 1.29559 2.15483 -15.9854 6.57991 +233 4 54.1789 12.1729 0.660397 -4.76608 7.18995 2.46446 +234 4 2.02372 12.0909 41.706 2.9877 17.6459 6.95349 +235 4 1.57896 11.139 40.2943 0.339955 -2.68366 6.65003 +236 4 2.50746 10.4017 41.6821 -7.50419 3.69742 -2.77337 +237 1 1.45709 7.55056 0.343709 0.783377 10.0466 -6.42735 +238 2 2.26763 6.65075 1.15078 -32.6055 -6.94536 -7.22798 +239 2 3.71498 6.9634 0.985171 49.9575 39.4499 -62.468 +240 3 4.16139 7.41516 41.7733 -24.7374 -20.1855 46.264 +241 4 1.86812 7.64334 41.3079 -3.10568 2.79536 2.39364 +242 4 2.02547 6.77359 2.21072 -7.15361 5.99983 10.1715 +243 2 1.97017 5.19949 0.677115 9.24237 23.8034 -8.70369 +244 2 0.525 4.76245 0.942436 -1.25511 -23.3688 27.6866 +245 2 0.292475 3.39123 0.300736 12.896 -21.1671 11.4366 +246 2 0.300138 4.59931 2.47443 -32.0383 1.7301 9.08136 +247 4 2.70003 4.54767 1.15632 6.2908 -16.3803 10.1517 +248 4 2.22696 5.13751 41.5068 -3.29253 -1.30987 -4.15087 +249 4 54.7656 5.47042 0.590489 -8.39992 14.3218 -15.0438 +250 4 54.2418 3.05018 0.328915 -13.2626 1.11831 3.00682 +251 4 0.884488 2.58096 0.823664 -4.50955 14.351 -5.98985 +252 4 0.593908 3.34298 41.1636 3.48003 3.40906 -16.1017 +253 4 0.952355 3.83641 2.92287 8.67303 -5.41594 2.10418 +254 4 54.195 4.2418 2.71744 29.7111 15.4634 -7.25797 +255 4 0.523461 5.5584 3.03176 -8.55492 -11.4476 -4.98522 +256 1 4.54724 6.69628 2.0028 -11.6083 -5.66543 -5.23244 +257 2 5.9708 6.78048 2.07185 29.6953 24.7002 11.5216 +258 2 6.62679 5.47067 2.57826 -56.9161 -25.5018 -48.7527 +259 3 7.55514 5.44421 3.3345 43.3901 -4.04961 27.9945 +260 4 4.11753 6.29088 2.82459 -1.31884 -6.15538 19.0144 +261 4 6.38329 6.99012 1.0501 -1.44469 -12.2628 1.79191 +262 2 6.4556 7.99651 2.97484 -29.1307 10.2847 -18.0571 +263 2 6.5028 9.34873 2.22705 -18.2939 24.7932 5.04877 +264 2 6.67525 10.5485 3.20576 -19.6949 -28.8822 -17.9407 +265 3 7.83409 10.9407 3.49149 14.4815 4.00472 5.8048 +266 3 5.6204 11.0576 3.67938 3.00737 1.04452 3.25275 +267 4 7.46376 7.72864 3.29072 15.5933 3.84479 14.8832 +268 4 5.82416 8.22265 3.87848 3.62309 -20.6245 -0.107855 +269 4 5.50278 9.55154 1.65377 27.7023 -9.35583 7.15892 +270 4 7.36204 9.37759 1.52673 -1.86837 -2.39822 -10.1271 +271 1 6.01547 4.32119 2.13096 24.825 18.8056 21.8908 +272 2 6.40109 2.94617 2.38906 -11.7575 -20.1643 -12.9237 +273 2 7.81521 2.61654 1.77783 -56.2322 2.45294 33.4207 +274 3 8.31478 3.35811 0.966233 17.239 19.087 -22.9985 +275 4 5.23593 4.40493 1.50032 -13.4301 6.78787 -12.4159 +276 4 6.42741 2.74871 3.48587 6.57798 6.02642 3.28221 +277 2 5.2086 2.00284 1.82478 32.9723 -19.5112 -16.552 +278 2 3.90497 2.10853 2.63909 4.11684 35.775 58.6384 +279 2 4.90372 2.28313 0.318971 -25.0993 -16.9694 6.10511 +280 4 5.56913 0.900136 1.85726 -4.66192 22.2662 6.6067 +281 4 4.03562 1.77943 3.74204 2.08752 -4.13501 -29.3045 +282 4 3.08076 1.58512 2.20328 -21.6762 -25.4002 -11.7361 +283 4 3.47043 3.14079 2.79739 15.5883 -5.24062 -11.8252 +284 4 4.40039 3.24668 0.146776 -5.79992 5.24774 -1.28692 +285 4 4.20501 1.47402 41.8336 8.41255 14.6516 3.66501 +286 4 5.77159 2.28177 41.569 16.6343 -1.64949 -4.80555 +287 1 8.4358 1.54559 2.27475 36.6082 -11.5601 -11.8896 +288 2 9.77403 1.09441 1.8307 -27.8835 12.6882 -14.7267 +289 2 9.60932 41.7912 0.904414 -8.95822 -4.80133 -2.77359 +290 3 8.60977 41.0717 1.04857 16.9017 -0.350054 -8.54673 +291 4 7.96937 0.851078 2.83344 -16.1443 -13.3321 15.6909 +292 4 10.1447 1.96102 1.23179 21.7718 -7.90657 2.9301 +293 2 10.6071 0.627222 3.03652 -0.441548 -3.06629 28.3632 +294 2 11.1182 1.69736 4.03374 -39.6019 -9.33118 23.345 +295 2 12.4276 2.26482 3.60541 40.3504 -3.80329 2.03759 +296 3 13.4833 1.65854 4.00477 -10.9735 16.3163 -6.96273 +297 3 12.4619 3.21875 2.76405 -4.75337 -1.04793 7.93588 +298 4 11.5429 0.117807 2.72279 -4.90068 -9.43781 -6.0473 +299 4 9.98495 41.7532 3.61242 16.0495 13.2539 -10.4034 +300 4 11.2741 1.17979 5.05068 -3.18835 9.28581 -16.8758 +301 4 10.3234 2.48031 4.23808 10.2695 -6.11036 -3.24845 +302 1 10.6563 41.4604 0.0588169 -6.20046 -15.666 -8.24155 +303 2 10.7096 40.1842 41.1911 4.64874 21.5238 9.65168 +304 2 10.6577 38.9638 0.161439 -6.67174 -46.3648 23.9629 +305 3 10.1435 37.8848 41.6696 11.1653 29.5239 15.2576 +306 4 9.85832 40.1011 40.5066 -14.3391 4.69386 -5.52668 +307 2 12.0141 40.2124 40.3653 4.26726 1.71904 -5.44169 +308 2 12.4668 41.6661 40.4777 -1.00635 15.6111 -33.0282 +309 2 11.8673 0.323303 41.767 -12.6506 -21.5702 -15.1443 +310 4 11.8545 39.873 39.2959 0.539662 6.91875 10.5587 +311 4 12.8304 39.5641 40.7546 -3.32338 -3.68521 7.20301 +312 4 12.0951 0.327352 39.5607 -0.26902 -6.73625 15.8499 +313 4 13.5766 41.7696 40.398 -3.05617 -0.547794 6.53436 +314 4 11.6542 1.3898 41.6565 2.06281 16.0871 1.21765 +315 4 12.5433 0.162045 0.691867 15.5992 2.8717 16.0141 +316 1 11.2193 39.0766 1.4086 -4.36655 24.7542 -22.059 +317 2 11.4309 38.0888 2.42328 2.01986 -2.25877 10.0578 +318 2 10.2357 37.7662 3.3374 -3.13249 5.62439 -12.9442 +319 3 10.4243 36.9709 4.25096 -6.41092 -9.96708 1.94465 +320 4 11.5904 40.0068 1.66465 -1.36758 -8.10945 4.45955 +321 4 11.6246 37.1209 1.91909 1.66244 -5.96089 -4.69733 +322 2 12.7089 38.4628 3.26447 -19.7243 1.96837 18.865 +323 3 12.593 39.7548 3.85012 -16.3579 -13.4437 -0.292868 +324 4 13.6002 38.4999 2.63657 13.9756 -7.10852 -11.694 +325 4 12.8962 37.7302 4.10036 -1.36843 4.44789 -10.4248 +326 4 11.9859 39.6657 4.60642 10.4094 13.6351 -5.41979 +327 1 9.02275 38.3618 3.12708 -24.8633 34.0603 -47.8229 +328 2 7.7797 38.1104 3.9237 -5.5143 -4.40103 -12.4219 +329 2 6.80948 37.1627 3.16843 27.134 16.5749 8.61656 +330 3 6.86683 37.0056 1.95165 6.52379 13.0808 -10.3152 +331 4 8.81363 38.9852 2.21874 13.7891 -35.0234 50.9651 +332 4 8.06628 37.5753 4.84119 7.22917 -10.5654 7.4735 +333 2 7.01568 39.4093 4.3407 2.69101 -11.9593 -14.7657 +334 2 7.81876 40.1019 5.42325 -6.79454 3.60365 -28.1432 +335 3 8.28496 41.241 5.20721 -2.75331 10.4655 -0.123769 +336 3 8.08719 39.4782 6.47272 0.652509 -5.2024 22.4807 +337 4 5.97814 39.1687 4.67547 5.82193 1.31451 7.85599 +338 4 6.83632 40.0167 3.42407 6.48365 7.00102 3.75656 +339 1 5.92582 36.4787 3.90047 -14.2639 -13.8348 21.4567 +340 2 4.95916 35.6178 3.24268 -4.4575 6.83929 8.3992 +341 2 3.83929 36.4769 2.71202 -44.4588 -49.3176 -48.5312 +342 3 3.60925 37.6169 3.05258 2.07424 26.7384 14.4764 +343 4 5.8145 36.534 4.942 7.63157 5.21975 -16.3776 +344 4 5.40617 35.1414 2.34351 4.65472 -4.22423 0.555341 +345 2 4.39718 34.509 4.16235 13.2774 -34.7614 9.16528 +346 3 3.98438 35.0519 5.39575 -10.4467 6.31908 32.28 +347 2 5.50619 33.4543 4.48033 -18.4692 -3.54598 29.0115 +348 4 3.53919 33.9402 3.74776 -4.47694 5.79242 -10.2957 +349 4 3.62452 34.3759 6.00064 11.5458 5.5573 -22.0279 +350 4 5.86065 32.9579 3.58801 8.19644 -6.15464 -22.9143 +351 4 5.08151 32.5761 5.12909 16.3877 29.7333 -11.6263 +352 4 6.39565 33.9521 4.95041 -3.85278 -8.84208 3.35803 +353 1 2.97294 35.7888 1.83357 24.6732 25.9217 25.2152 +354 2 1.71267 36.3687 1.37347 -5.03432 -5.896 10.5631 +355 2 0.744229 36.5497 2.58991 -5.24139 24.3125 -23.8477 +356 3 54.9871 37.5497 2.63122 18.6385 -17.0409 3.73872 +357 4 3.28773 34.8825 1.44268 -6.98273 2.93822 -0.272558 +358 4 1.87243 37.434 1.07109 4.86902 -3.5162 -5.74397 +359 2 1.111 35.5523 0.154125 -16.9781 -2.34719 28.1775 +360 2 1.71191 35.9998 40.7076 5.75717 0.931703 -28.4951 +361 2 54.5365 35.7134 0.116808 -8.16561 0.919103 1.38616 +362 2 3.27145 35.9095 40.6267 -43.0781 7.09941 -3.6072 +363 4 1.31237 34.4411 0.36052 2.96229 18.9121 -10.1464 +364 4 1.38444 37.0145 40.3207 4.07875 -5.77915 19.4423 +365 4 1.27316 35.3433 39.9124 8.37762 -5.40948 6.65521 +366 4 54.0772 35.0942 41.2103 3.74338 3.48587 4.89864 +367 4 54.2123 36.7722 41.8688 5.5832 -2.69651 -3.34762 +368 4 54.0157 35.4055 1.08169 10.5414 -0.491815 -14.4897 +369 4 3.61367 34.902 40.8802 7.83264 -12.2373 1.45006 +370 4 3.69229 36.6315 41.3343 12.2091 5.94613 6.19684 +371 4 3.59275 36.1798 39.604 6.95495 -3.49191 -4.00644 +372 1 0.74604 35.6172 3.54454 -3.3388 -35.9018 49.598 +373 2 0.0112331 35.6552 4.85892 21.257 7.22823 -39.6883 +374 2 0.198256 37.0471 5.48367 -2.86302 -31.8341 -17.2866 +375 3 54.1912 37.6952 5.75353 -1.48181 26.0574 3.92406 +376 4 1.16676 34.6739 3.4098 -0.571923 12.3969 -9.16993 +377 4 53.9399 35.5324 4.59955 -13.6683 1.62606 4.36563 +378 2 0.479844 34.4894 5.77304 -8.63544 -0.437888 22.4632 +379 2 54.7769 34.3327 7.14546 -8.87326 -9.27459 2.92058 +380 2 0.0146857 35.4787 8.12524 6.60033 -5.57439 2.5368 +381 3 54.0952 36.3427 8.3329 8.35004 -1.43527 5.86114 +382 3 1.11008 35.478 8.75909 4.47833 6.11486 1.03148 +383 4 1.57132 34.5563 5.98457 -0.698959 1.91632 -4.64924 +384 4 0.309529 33.5134 5.28188 2.4365 -3.54209 -11.468 +385 4 0.179249 33.4003 7.64738 0.479338 5.67065 -5.66203 +386 4 53.6776 34.105 7.04833 9.83525 6.91672 -4.06122 +387 1 1.48459 37.3964 5.63734 26.9411 18.0032 -4.38534 +388 2 2.00708 38.6625 6.18614 -17.3218 -26.0277 -29.9987 +389 2 1.56827 39.8885 5.33406 1.07082 -15.6319 68.2882 +390 3 1.08143 40.8395 5.94485 1.04665 3.34176 -10.6171 +391 4 2.21263 36.6994 5.39095 -3.57075 5.04293 0.958686 +392 4 1.48422 38.7142 7.17744 15.2971 12.5748 0.959573 +393 2 3.55969 38.5843 6.25222 7.32448 -15.8569 15.0135 +394 2 4.09689 39.7132 7.09894 -5.63198 1.92213 9.01267 +395 3 4.56636 40.7179 6.56654 0.030916 3.04529 -1.1693 +396 1 3.96361 39.556 8.43894 1.042 12.9555 16.4237 +397 4 4.05831 38.7157 5.24953 -10.2579 -5.90723 4.64011 +398 4 3.91694 37.5778 6.70114 -5.07122 23.1073 -10.2752 +399 4 3.40266 38.7698 8.86734 10.6722 14.2638 -7.23316 +400 4 4.31989 40.3411 9.06061 -10.7144 -22.9188 -14.0526 +401 1 1.60475 39.819 4.02334 -43.55 39.5967 -43.6917 +402 2 0.959151 40.8062 3.12947 9.93922 10.0651 20.657 +403 2 54.4776 41.0208 3.48285 -52.4492 -13.4217 15.5726 +404 3 53.9715 0.237442 3.65017 19.1527 -10.2385 2.60078 +405 4 2.04263 39.1125 3.49268 25.4866 -43.7222 -11.6271 +406 4 1.43469 41.7946 3.36052 -1.16639 -0.650149 -3.04645 +407 2 1.13376 40.5205 1.61049 -4.45578 -2.70165 -27.9407 +408 2 0.490261 41.6149 0.695896 4.53105 0.20202 29.6943 +409 2 2.64975 40.4484 1.23692 -3.92583 -1.39436 -18.6979 +410 4 0.60342 39.5705 1.32385 8.41785 -1.89228 7.96418 +411 4 54.3692 41.6195 0.82936 4.25856 9.6792 3.81375 +412 4 0.622371 41.4492 41.5424 7.52435 -6.48816 -19.7965 +413 4 0.973053 0.688907 0.936332 -12.1275 -4.49455 -2.44597 +414 4 2.86969 40.4983 0.122209 -12.9804 -12.5133 18.6513 +415 4 3.14027 39.5547 1.69882 2.20392 3.04031 -6.93039 +416 4 3.17994 41.3387 1.56797 8.55742 10.8937 16.8775 +417 1 53.6665 39.902 3.64569 3.02926 35.878 11.6697 +418 2 52.2466 39.9148 4.06102 19.2385 27.0707 -26.8098 +419 2 52.053 40.5369 5.44904 5.36155 -11.3244 -6.70427 +420 3 51.0493 41.2119 5.6977 3.00195 1.8183 -1.23959 +421 4 54.0359 38.9941 3.4462 12.1828 -26.316 -3.91411 +422 4 51.7731 40.6655 3.34079 -4.82064 -14.7659 11.8755 +423 2 51.582 38.5149 3.95778 -5.61462 -20.1546 -9.91009 +424 2 51.4355 37.9559 2.49174 21.0062 -12.2216 22.8132 +425 2 51.0144 36.4629 2.37849 -12.7289 -13.0945 -11.3158 +426 2 50.8009 35.9817 0.883468 22.3055 45.8074 13.5352 +427 1 50.1864 34.6873 0.684667 2.36531 28.1154 -10.556 +428 4 50.5344 38.5648 4.38466 13.3699 -2.49694 2.21203 +429 4 52.2198 37.7725 4.53757 -13.8611 9.51826 -2.20414 +430 4 52.4594 37.9738 2.01537 -10.7122 14.3169 -4.94324 +431 4 50.6781 38.6054 2.01085 7.27079 0.282464 -15.5314 +432 4 50.0599 36.3043 2.92579 -2.19776 -0.350037 2.41174 +433 4 51.7586 35.7685 2.83822 0.223715 4.6579 4.31096 +434 4 51.8274 35.9658 0.402852 -15.0801 -2.53131 0.358002 +435 4 50.2142 36.8299 0.38331 4.02889 -26.7998 -2.47013 +436 4 50.6312 33.9821 1.2741 -7.74727 -6.99272 -14.4028 +437 4 50.1255 34.5169 41.5875 17.6482 -15.4813 7.31014 +438 4 49.2229 34.7469 0.909632 -22.6621 -5.40937 19.0501 +439 1 53.014 40.2496 6.3528 -7.33511 22.7823 24.6419 +440 2 53.0995 40.7279 7.73814 -49.8191 -29.044 -3.24915 +441 2 53.1557 0.329785 7.7965 36.8238 12.814 -39.8954 +442 3 52.5287 0.997511 8.60414 -15.9304 4.02299 13.5617 +443 4 53.7341 39.5741 6.15629 12.7417 -17.108 -13.0125 +444 4 52.0658 40.401 8.2322 35.0205 13.5384 -7.46142 +445 2 54.2887 40.0362 8.44194 -31.1952 -6.28028 37.9979 +446 4 54.3393 40.3597 9.51814 11.9598 15.0179 -15.3163 +447 4 0.207826 40.1934 7.85611 17.4499 5.7482 6.56468 +448 4 54.1321 38.9464 8.61757 0.233079 -2.0185 -17.8759 +449 1 53.9798 0.938968 6.8679 -0.195991 -19.5991 -5.8991 +450 2 54.0539 2.3703 6.69095 -13.0728 33.3033 12.6105 +451 2 52.7411 3.03405 6.19669 -13.7918 -57.342 -43.9621 +452 3 52.3429 4.1409 6.51048 0.805927 21.8583 24.6591 +453 4 54.6966 0.402301 6.30051 -22.9471 7.504 14.9388 +454 4 54.1387 2.85352 7.70963 6.90446 -7.48262 -5.16091 +455 2 0.230181 2.82991 5.77971 -8.39605 37.5401 -18.7849 +456 2 1.62806 2.36187 6.13631 43.8101 -17.859 13.5365 +457 2 2.01439 2.63812 7.6434 4.44409 -15.8917 -34.667 +458 2 3.251 1.82053 8.03886 10.3698 -25.435 21.3536 +459 1 3.78609 2.13458 9.37971 -1.03569 -21.7613 -70.4054 +460 4 0.236987 4.00662 5.72725 -0.841737 -32.3075 1.88093 +461 4 55.0233 2.47547 4.72977 -1.92078 4.0191 4.58104 +462 4 2.43886 2.84427 5.52141 -13.7997 6.98566 -1.14785 +463 4 1.8001 1.26942 5.8525 -13.1218 12.7308 11.199 +464 4 1.17734 2.2629 8.25415 -4.76662 9.03037 15.6753 +465 4 2.26439 3.72233 7.77766 -11.2971 -1.006 3.39024 +466 4 4.0605 1.91272 7.29579 6.96563 5.43042 -1.59904 +467 4 3.03028 0.709673 8.06144 -4.99399 12.6268 -3.20223 +468 4 3.89697 1.2978 9.90866 2.2165 -13.9672 17.3419 +469 4 3.11983 2.70535 9.83652 -2.18207 25.7622 26.4666 +470 4 4.71792 2.51816 9.23842 -3.78155 13.4581 18.6473 +471 1 52.0021 2.30339 5.27929 12.8772 20.7449 44.6796 +472 2 50.6928 2.72834 4.84618 -13.8318 -0.832969 -24.58 +473 2 49.579 2.58092 5.91693 0.565718 25.7533 -2.22664 +474 3 48.7752 3.51298 6.10069 9.60089 -13.9081 0.0850852 +475 4 52.4111 1.47967 4.84803 3.54375 -13.752 -6.04623 +476 4 50.7183 3.81521 4.5849 2.62435 0.742467 8.46338 +477 2 50.3339 2.0499 3.47904 12.4361 -26.7668 8.24264 +478 2 51.3981 2.34325 2.36407 -25.9391 22.844 -14.5031 +479 2 48.9153 2.37958 2.98651 -2.89914 40.9383 9.35249 +480 2 51.1891 1.41918 1.15407 38.5806 -15.4927 -30.3188 +481 4 50.4158 0.92469 3.65006 -8.90797 13.02 4.48026 +482 4 52.4055 2.20648 2.74929 18.7984 -5.45377 5.09466 +483 4 51.3666 3.42411 2.00589 -1.76359 -13.5005 7.53435 +484 4 48.1353 2.36077 3.79579 2.75746 -16.6411 -10.078 +485 4 48.6799 1.76326 2.11438 -14.9792 -11.0957 -5.84075 +486 4 48.8325 3.45193 2.63807 7.50371 -11.7896 -0.401559 +487 4 52.1004 1.43799 0.414216 -21.3416 1.39174 26.2203 +488 4 50.3409 1.68288 0.503068 -10.2032 3.93981 2.99084 +489 4 51.0565 0.33979 1.46483 1.72575 11.8892 -3.22767 +490 1 49.5807 1.53255 6.75244 19.5889 -24.3514 7.76629 +491 2 48.7262 1.39688 7.92951 3.12598 20.2674 -1.73108 +492 2 48.8873 2.63773 8.86406 -22.8968 -16.6402 -5.42224 +493 3 47.8891 3.05472 9.45614 -0.472007 6.27789 -5.95623 +494 4 50.2352 0.731103 6.58688 -10.8709 15.7502 1.66713 +495 4 47.6402 1.39986 7.60999 11.2933 -0.131061 -1.07735 +496 2 49.0614 0.0990051 8.70607 -29.9824 -25.1823 -11.7347 +497 2 48.2869 41.7602 10.01 13.4599 -0.122667 29.7563 +498 2 46.7828 0.0292377 10.0132 -0.929007 -24.4408 -23.1824 +499 3 46.2118 0.52149 10.9702 -12.9016 15.2185 13.9881 +500 1 46.1401 41.3429 8.96595 27.5879 22.2376 34.4467 +501 4 50.107 0.108866 8.97457 27.7162 -1.73681 3.74735 +502 4 48.8999 41.0818 8.03917 5.36927 20.2302 10.0129 +503 4 48.7183 0.460982 10.852 -8.35522 8.57003 -12.646 +504 4 48.4869 40.755 10.454 -1.65554 -4.90235 -14.5783 +505 4 46.6392 40.8985 8.22302 16.4703 -11.2583 -22.7525 +506 4 45.1487 41.2958 8.97726 -40.9601 -1.33251 0.190018 +507 1 50.0995 3.17318 9.05078 3.95851 -0.0485648 -3.79593 +508 2 50.3325 4.25644 9.97415 17.5873 21.0859 -2.62556 +509 2 49.9752 5.63804 9.37548 -18.0954 -29.5198 29.938 +510 3 49.379 6.45094 10.0988 9.73071 -4.74536 -2.58342 +511 4 50.9107 2.76055 8.59957 11.9693 -5.38147 -4.75744 +512 4 49.6509 4.09994 10.8399 -6.9467 2.38538 1.23714 +513 2 51.7744 4.26209 10.561 -12.6039 -21.2869 -0.279481 +514 2 51.8614 5.17465 11.7883 77.4573 -1.34868 -55.222 +515 3 50.9415 5.19238 12.5756 -62.6641 4.37367 45.7089 +516 3 52.9385 5.83334 11.9521 -15.5069 -3.45829 -0.856418 +517 4 52.5513 4.49045 9.80335 -1.41111 7.91559 -3.33271 +518 4 51.9847 3.17606 10.8252 3.56611 15.7947 8.37571 +519 1 50.1134 5.83384 8.05697 5.03044 -3.38183 -24.9476 +520 2 49.6949 7.07302 7.45907 -6.39224 21.6045 -14.6025 +521 2 48.2404 7.19765 6.96855 9.41443 -40.5535 -11.5325 +522 3 47.5994 8.23003 7.09737 -2.60339 17.4007 5.13595 +523 4 50.5903 5.18529 7.39903 -4.72806 0.48988 13.3104 +524 4 49.6568 7.79446 8.28532 6.84483 14.8177 6.93296 +525 2 50.7045 7.63108 6.39006 -19.8247 -9.47824 8.02755 +526 2 50.6996 6.84785 5.08902 -10.629 2.31661 -15.1243 +527 2 51.6586 7.26626 3.9659 -11.3496 43.5825 3.95364 +528 2 53.1317 7.00105 4.2557 32.8208 18.7244 -18.8206 +529 1 53.7683 7.95578 5.14747 -10.6729 7.59108 -11.9454 +530 4 51.7028 7.64661 6.81348 16.7201 -1.45014 11.0251 +531 4 50.4708 8.68128 6.19684 -5.34256 14.1207 -5.41714 +532 4 49.6713 6.8702 4.6668 -0.861277 1.74329 -1.61352 +533 4 50.8688 5.79892 5.31654 5.28855 -19.0543 2.54637 +534 4 51.4741 8.35024 3.65396 8.42695 -12.5098 16.2485 +535 4 51.3565 6.79125 3.04708 -1.5826 -26.0582 -19.3792 +536 4 53.7673 7.0998 3.31183 -20.6632 -9.77681 9.39502 +537 4 53.2972 5.98514 4.64126 3.7215 -8.75629 2.11801 +538 4 53.3251 8.87081 5.17658 4.71004 0.103302 -2.74719 +539 4 54.7439 8.12131 4.95956 10.0262 2.1061 -7.58392 +540 4 53.7752 7.60869 6.06781 -3.05466 -8.65204 35.212 +541 1 47.7159 6.1092 6.3306 31.3529 14.3598 14.0351 +542 2 46.4076 6.11425 5.7591 -25.7668 -19.0326 -13.8071 +543 2 45.4013 5.23171 6.47844 56.1675 -11.9112 16.6864 +544 3 44.23 5.34684 6.24133 -49.2229 2.39302 -4.99484 +545 4 48.3398 5.28969 6.15889 -17.2258 10.451 -1.21207 +546 4 45.9358 7.11624 5.83656 4.3919 7.44058 4.79016 +547 2 46.401 5.6982 4.25555 12.45 -16.5042 -24.1702 +548 2 46.8608 6.82251 3.28226 -4.83626 -15.1342 -13.4955 +549 2 46.0803 8.13881 3.30599 -14.5444 -4.79224 -13.1752 +550 3 44.9716 8.27119 2.67975 10.7775 -8.64163 7.28309 +551 3 46.5691 9.08454 3.95876 4.86602 16.815 8.62941 +552 4 45.3845 5.39013 3.90204 -1.72737 6.76951 8.44594 +553 4 47.0179 4.72632 4.06618 -9.2699 26.8442 8.77601 +554 4 46.8747 6.40942 2.20799 2.04532 8.89503 18.2744 +555 4 47.9008 7.08537 3.56457 7.18737 -1.18981 -5.53646 +556 1 45.8799 4.29222 7.33829 -37.7514 2.20406 -4.61566 +557 2 44.9987 3.41141 8.06424 -3.99299 1.7641 -5.76947 +558 2 44.3276 2.33248 7.21969 -45.1266 -42.7281 27.6017 +559 3 43.411 1.613 7.73718 25.6836 24.6852 -13.962 +560 4 46.8488 4.10168 7.49502 31.0353 -1.43619 1.82022 +561 4 45.5349 2.87862 8.87403 3.80662 2.65181 2.49747 +562 4 44.2009 4.01738 8.56522 2.51171 -3.43938 -1.53795 +563 1 44.7359 2.05713 5.97006 1.92732 3.23614 21.462 +564 2 44.1948 0.978467 5.13766 -26.7101 17.135 -13.9432 +565 2 44.8486 41.5478 5.5025 3.41127 -20.6454 16.5554 +566 3 46.0871 41.4431 5.57675 -14.0525 11.0231 2.35631 +567 4 45.5581 2.59183 5.73006 15.6975 -3.64086 -27.3416 +568 4 43.0338 0.980574 5.28193 28.569 -9.56263 1.83686 +569 2 44.4255 1.37435 3.62453 6.02041 -5.1027 -4.41971 +570 2 43.5303 2.62118 3.29791 4.64703 16.7196 -23.7169 +571 2 44.2051 0.148173 2.67978 -29.1583 2.83252 11.5038 +572 2 43.5747 3.10962 1.83395 1.21002 2.08355 -6.515 +573 4 45.4937 1.66977 3.44724 -0.165314 0.952935 9.41179 +574 4 43.8006 3.52551 3.92139 -2.56937 -12.5949 1.07415 +575 4 42.4611 2.43664 3.46298 -10.2855 -9.14552 12.9963 +576 4 44.5119 0.377143 1.64896 8.27723 -0.881131 -7.54742 +577 4 43.1044 41.7625 2.59144 16.8524 3.81389 6.96191 +578 4 44.7846 41.171 3.05101 -3.46686 1.83863 -12.0461 +579 4 44.5392 3.56167 1.57116 9.55733 8.13116 4.62467 +580 4 42.7809 3.86627 1.57982 6.14378 -4.69974 7.81616 +581 4 43.4757 2.31615 1.08375 -8.22918 -11.6964 -1.57482 +582 1 44.0839 40.4233 5.76821 21.932 -1.5334 -8.86254 +583 2 44.7424 39.1674 6.24443 -3.28027 29.5462 -2.23354 +584 2 45.6232 38.4648 5.15467 16.5957 -3.17533 31.1682 +585 3 45.1655 38.1269 4.0769 -9.06079 2.14789 -9.97198 +586 4 45.3594 39.5074 7.13461 -7.15079 -15.4686 -7.49065 +587 2 43.5266 38.3049 6.70081 12.2837 2.36218 -7.01546 +588 2 42.3912 38.8204 5.83129 -5.25874 0.19697 14.2242 +589 2 42.6515 40.3318 5.90174 -25.8883 17.7161 37.6601 +590 4 43.2615 38.5482 7.76954 6.63706 -13.879 -3.94164 +591 4 43.7406 37.2122 6.50504 -6.24398 7.50926 12.4246 +592 4 41.3856 38.4747 6.1895 5.24712 7.09666 -1.13826 +593 4 42.5101 38.4102 4.83081 -0.0162975 -1.57753 -20.806 +594 4 42.2783 40.7857 6.94925 18.7272 -16.9878 -38.5107 +595 4 42.0764 40.8825 5.13323 2.00122 -0.967094 -8.03005 +596 1 46.8623 38.0021 5.57674 -15.3549 -23.0767 -9.82664 +597 2 47.7161 37.0187 4.84527 -3.88045 42.2808 23.2471 +598 2 47.0384 35.8723 4.15029 10.1677 -9.37304 -39.3599 +599 3 47.4551 35.4743 3.0324 -9.4669 19.846 29.5852 +600 4 48.2252 37.6386 4.0698 7.54977 -11.2433 -2.33648 +601 2 48.6452 36.5035 5.99482 -10.0312 13.1223 -5.95218 +602 2 48.8959 37.7819 6.80046 -4.41071 -5.72741 24.5975 +603 2 47.4918 38.4151 6.80561 23.284 1.3706 -4.72721 +604 4 49.5844 36.0861 5.59811 5.91725 -9.04521 -0.913385 +605 4 48.1158 35.748 6.64071 6.83063 -0.71303 -5.46675 +606 4 49.6383 38.4449 6.34864 7.02588 7.83512 -10.7506 +607 4 49.3019 37.5753 7.85532 -11.9914 1.76609 -18.7023 +608 4 47.544 39.5162 6.85821 3.72706 6.34433 1.60956 +609 4 46.9486 38.0654 7.68542 -11.5693 -5.06488 12.3189 +610 1 46.0019 35.318 4.78064 -26.4221 -3.88232 27.7903 +611 2 45.3025 34.13 4.26579 26.8092 19.3149 11.5505 +612 2 44.4585 34.46 3.02929 16.6723 1.23881 35.6677 +613 3 44.3932 33.6565 2.12406 -6.96945 -13.3218 -23.6344 +614 4 45.6895 35.6839 5.72645 6.17072 -11.3773 -21.4598 +615 4 46.1371 33.4525 3.9443 -9.57056 -4.48549 -9.01935 +616 2 44.5851 33.4333 5.41517 7.28023 -34.3989 -9.31284 +617 2 43.896 32.1478 4.95943 -2.5072 53.7563 23.2534 +618 3 42.6929 32.0377 5.28407 -11.6877 -17.8688 -5.68187 +619 3 44.6212 31.2997 4.42805 15.8429 -32.9345 -13.4225 +620 4 43.8908 34.1037 5.87793 -28.8167 18.0933 10.1447 +621 4 45.2673 33.1449 6.25678 1.67129 3.14432 -6.05002 +622 1 43.9425 35.6996 2.93756 -0.354949 -32.7532 -51.8723 +623 2 43.3733 36.2033 1.70184 -38.6892 -13.1006 14.7431 +624 2 44.3694 36.8017 0.73913 15.0439 4.82349 -39.1461 +625 3 44.0609 36.9601 41.4463 -0.757384 -5.0254 19.6545 +626 4 44.0082 36.3398 3.67638 4.88567 37.3717 42.7902 +627 4 42.8639 35.3314 1.17484 15.8753 7.76257 0.915116 +628 2 42.1931 37.1947 1.98861 35.687 20.598 -23.7763 +629 2 41.116 36.6037 2.88066 -6.28281 10.7168 27.7809 +630 2 39.8788 37.4748 2.97821 -20.6793 -12.2331 -39.8799 +631 3 39.5744 38.0012 4.02693 -4.5695 14.1805 28.3661 +632 1 39.0796 37.534 1.86047 23.989 -9.69865 9.57867 +633 4 41.7899 37.5369 1.00167 -6.59533 -6.76427 4.06671 +634 4 42.6371 38.1477 2.39011 -7.96796 -7.2267 7.32793 +635 4 41.4745 36.4913 3.95075 -0.75248 -0.913082 -13.6466 +636 4 40.7949 35.61 2.55083 -3.16107 -12.1939 -5.02302 +637 4 39.3636 37.1043 0.951835 -4.89499 3.13933 11.6446 +638 4 38.1602 37.9899 1.92801 1.07188 2.17452 -2.18356 +639 1 45.5977 37.1878 1.1702 -15.0402 3.91697 -26.2999 +640 2 46.6124 37.7593 0.269692 0.961344 -25.1749 -6.20454 +641 2 47.1251 36.6298 41.227 -15.6894 27.1972 18.7996 +642 3 47.6617 35.6605 41.7393 11.2436 -21.3221 -9.23089 +643 4 45.7953 37.0706 2.14421 15.4189 2.49224 25.3654 +644 4 46.1246 38.4981 41.5406 -7.74237 14.7139 -7.84953 +645 2 47.8075 38.4099 1.03092 10.1012 15.6193 -18.1996 +646 2 47.4246 39.6903 1.82563 -12.4684 -22.6418 23.6998 +647 2 48.6005 40.4099 2.51691 -17.3417 -7.9082 6.23218 +648 3 49.6876 40.5582 1.97833 4.99301 -0.872474 -9.60266 +649 1 48.339 40.8761 3.75079 34.2245 13.1834 24.2049 +650 4 48.6123 38.7237 0.293834 -9.9427 -4.45455 6.13719 +651 4 48.2879 37.6501 1.66455 2.7768 -3.8165 9.90104 +652 4 46.6323 39.34 2.60232 21.0344 18.1725 -15.5096 +653 4 46.9544 40.4315 1.1644 -6.65764 6.44375 -5.56957 +654 4 47.4103 40.9551 4.17425 -6.86232 -2.61251 -1.04516 +655 4 49.1568 41.2536 4.3255 -23.3959 -10.5461 -18.532 +656 1 47.0132 36.8194 39.8944 4.79393 -10.5252 -5.84263 +657 2 47.6604 36.043 38.8342 19.1375 -30.0942 8.85154 +658 2 48.4687 37.0132 37.9763 6.82075 18.1877 -22.3602 +659 3 47.9595 37.6039 37.0009 8.77071 -9.81154 18.2462 +660 4 46.405 37.5569 39.5258 -2.34297 5.9549 -2.23138 +661 4 48.4229 35.2731 39.2798 -19.3933 25.0679 -4.92238 +662 2 46.6775 35.1997 37.9517 0.490197 24.678 -10.7229 +663 2 46.0672 34.0096 38.7198 -38.9175 -0.700818 10.3629 +664 2 46.8744 32.685 38.9073 -3.26917 9.79703 -36.9848 +665 1 47.7628 32.6295 40.0786 -15.9706 28.2316 14.6984 +666 2 48.51 31.5331 40.3435 -4.63001 14.745 41.8738 +667 1 48.7312 30.5422 39.5064 -7.34995 -4.23697 -9.55446 +668 1 48.9018 31.3819 41.635 -19.9532 28.2508 -37.0556 +669 4 47.1729 34.8887 37.0027 6.80802 -10.5296 7.48075 +670 4 45.9076 35.9114 37.5121 1.10402 -9.8189 16.5264 +671 4 45.0997 33.7597 38.1755 17.1722 -3.36537 -3.11703 +672 4 45.6001 34.3514 39.6854 13.8349 -0.884929 -1.62484 +673 4 47.4022 32.4647 37.9216 2.87405 7.70981 18.3952 +674 4 46.1271 31.862 38.9206 0.553217 -4.0431 12.8995 +675 4 47.6279 33.4362 40.8042 9.43822 -37.2826 -24.9694 +676 4 48.3342 30.5657 38.5603 0.826291 -3.97588 -2.82687 +677 4 49.185 29.675 39.7859 6.04467 -9.07236 4.91997 +678 4 48.5432 32.0104 0.443983 -2.47374 7.53927 7.97734 +679 4 49.3442 30.5519 41.958 17.8055 -32.7958 11.0172 +680 1 49.7507 37.2761 38.36 -27.9891 3.94923 -10.3626 +681 2 50.6372 38.1716 37.6465 6.90802 9.01894 -16.7299 +682 2 51.1009 37.4739 36.3314 6.00851 -0.000986305 0.302592 +683 3 51.4496 36.2941 36.3505 -3.04594 -4.29189 2.8804 +684 4 50.1774 36.6397 39.0138 14.1864 -12.0724 14.4781 +685 4 50.0595 39.0583 37.2837 -1.51256 1.6517 8.14679 +686 2 51.8464 38.6091 38.5553 2.49074 0.426256 -22.3009 +687 2 51.5192 39.49 39.8069 -13.5557 -5.73698 -8.16935 +688 2 52.7888 39.6608 40.6664 -21 22.821 44.9745 +689 2 51.0354 40.8913 39.3667 -19.684 19.0705 -14.0846 +690 4 52.5817 39.1556 37.8894 -7.88883 -2.40182 8.97054 +691 4 52.3725 37.6699 38.8321 2.26719 1.04002 8.03718 +692 4 50.6848 39.0041 40.3963 9.50705 2.70236 -0.692257 +693 4 52.9505 38.8088 41.3668 0.716139 -3.31122 -6.89789 +694 4 52.7117 40.5855 41.3722 -1.5977 -23.2904 -18.3054 +695 4 53.6872 39.819 40.0903 21.6097 1.4026 -14.7648 +696 4 51.7777 41.4333 38.7338 5.73144 0.910017 10.7761 +697 4 50.6933 41.5309 40.2327 12.7628 -5.43827 -4.45399 +698 4 50.1361 40.9136 38.7005 3.06807 -14.6998 5.44273 +699 1 51.1637 38.2069 35.1833 -8.65277 46.2898 44.1617 +700 2 51.553 37.7419 33.8846 1.56046 15.8517 -26.9219 +701 2 52.7972 38.5563 33.3946 6.24297 -42.3048 -4.64985 +702 3 52.8896 39.7642 33.5814 -6.435 17.9384 2.35192 +703 4 50.9569 39.2647 35.262 8.21378 -41.2603 -12.3383 +704 4 51.8027 36.6701 33.8819 4.46523 -10.0245 6.73196 +705 2 50.2986 37.9511 32.9329 -9.17145 -5.64023 18.3882 +706 2 49.0629 37.0889 33.4059 8.5101 -2.50878 -15.0431 +707 2 50.6601 37.6697 31.4816 -9.00198 -6.28682 -34.5666 +708 2 49.2037 35.5513 33.2317 13.0867 -6.63955 11.9256 +709 4 49.9372 39.0006 33.0238 8.27291 6.69816 -3.39278 +710 4 48.1686 37.4323 32.8001 8.11156 -5.69031 9.58675 +711 4 48.8477 37.3684 34.464 -5.28515 -5.82898 -0.156702 +712 4 49.7508 37.5287 30.8047 12.011 -0.0430796 16.0089 +713 4 51.2928 36.7446 31.376 -4.11156 8.47591 0.32382 +714 4 51.1768 38.5507 31.0175 4.51478 -6.96789 5.36543 +715 4 50.1453 35.1216 33.7014 -11.0082 12.206 -5.4516 +716 4 49.2178 35.23 32.1578 -3.59036 3.22922 4.55632 +717 4 48.3665 35.0295 33.7638 0.68062 2.42879 -7.65558 +718 1 53.772 37.8505 32.7005 11.9802 38.3584 -9.99311 +719 2 54.8892 38.4918 31.9453 -18.9337 33.3604 36.4373 +720 2 0.0457823 37.9282 30.5422 -8.24024 2.92716 -24.5162 +721 3 0.594264 36.8423 30.3259 -11.3073 1.50903 5.31397 +722 4 53.7906 36.8495 32.616 -6.44893 -30.0966 2.1434 +723 4 54.5933 39.6185 31.9763 4.67753 -27.1194 -20.6963 +724 2 1.30394 38.4484 32.6241 4.82921 -5.73508 14.5601 +725 2 2.2605 39.423 31.9346 -38.1373 19.2777 23.8899 +726 2 1.83713 40.7771 31.9484 17.1926 2.24265 -1.86924 +727 2 3.4991 39.1266 31.4137 44.2785 -3.28979 -22.8275 +728 2 2.64242 41.8019 31.4282 -29.5168 1.86603 13.0701 +729 2 4.3212 40.1796 30.8558 3.27898 -39.2743 8.81887 +730 2 3.87185 41.4777 30.8782 6.24363 43.3598 -8.15054 +731 4 1.73925 37.4095 32.5315 -6.00214 7.91305 5.68876 +732 4 1.22265 38.7505 33.7444 5.52003 -9.57077 -28.715 +733 4 0.900292 41.0813 32.4345 -2.25415 1.01323 1.36593 +734 4 3.85804 38.0586 31.4239 -1.87041 17.6471 -1.97414 +735 4 2.21075 0.929728 31.5263 16.6224 -11.4708 -8.14622 +736 4 5.34427 40.0148 30.4252 -14.7168 -7.47964 5.81345 +737 4 4.49601 0.410438 30.4759 -4.95559 -13.7664 3.94973 +738 1 54.5157 38.6773 29.5249 -27.0888 35.6462 7.20647 +739 2 54.4663 38.361 28.1069 5.2815 -2.56059 -27.0064 +740 2 53.8105 37.007 27.8285 4.1142 -30.4598 -15.4676 +741 3 54.2925 36.1623 27.0158 -8.84 24.3654 24.6709 +742 4 54.0165 39.6075 29.7175 18.6271 -30.7219 2.56864 +743 4 53.83 39.1099 27.5328 0.819814 -7.88342 20.1611 +744 2 0.845681 38.4599 27.4009 -3.37868 13.1124 0.920574 +745 4 1.3644 39.4179 27.7359 0.635395 -16.0183 -8.53916 +746 4 0.720089 38.4757 26.2839 -0.330424 7.67272 7.0695 +747 4 1.43916 37.5478 27.5772 11.0328 -1.07232 10.5421 +748 1 52.6562 36.7643 28.4919 4.43857 42.1876 29.7882 +749 2 51.8688 35.5726 28.5678 11.3762 10.3615 -9.24037 +750 2 52.1836 34.677 29.7554 -56.6515 -45.7393 26.8579 +751 3 51.2796 33.8674 30.1477 33.9368 21.5747 -13.7315 +752 4 52.2409 37.5914 29.034 7.3769 -32.5773 -16.326 +753 4 50.8037 35.9045 28.6197 0.824464 -11.9292 4.40922 +754 4 51.9818 34.9789 27.6186 -1.74208 2.17118 9.08886 +755 1 53.386 34.609 30.3327 15.9463 0.295407 3.2668 +756 2 53.8702 33.5918 31.2906 -5.336 7.3854 -1.97925 +757 2 53.2724 33.784 32.6972 3.62039 -3.18208 -20.5224 +758 3 53.318 34.8834 33.2435 -3.37109 6.20646 2.08258 +759 4 54.0584 35.341 30.1321 12.3398 9.17802 -3.54281 +760 4 53.5469 32.5903 30.928 0.510164 -2.93777 -2.78072 +761 2 0.450375 33.6574 31.3834 -19.8167 20.6669 9.28695 +762 2 1.1189 33.1041 30.1021 -5.33927 -7.82927 4.13606 +763 2 2.62926 33.3565 30.0201 27.5042 -3.46073 -5.185 +764 2 3.52676 32.4236 30.898 -7.76336 10.6891 3.26174 +765 1 4.93921 32.7908 30.8651 -15.3408 -23.1293 6.29736 +766 4 0.715906 33.1135 32.3077 13.219 -7.49284 0.339296 +767 4 0.711888 34.7596 31.5921 3.25804 -21.2431 -6.20467 +768 4 0.610971 33.6189 29.2485 6.53106 -4.93764 -4.86032 +769 4 0.94328 31.9817 29.9891 -3.372 16.4508 0.497364 +770 4 2.92569 34.3879 30.2717 -10.3735 11.8265 3.32189 +771 4 2.96748 33.277 28.9434 -5.36763 -4.46501 9.75656 +772 4 3.3856 31.3899 30.5364 6.91643 -9.08032 2.48396 +773 4 3.23325 32.4634 31.9813 -4.58699 -1.94284 -9.93441 +774 4 5.35439 32.7181 29.9584 6.30767 5.94328 -10.9381 +775 4 5.52691 32.2429 31.4849 -0.455553 -3.36681 1.56927 +776 4 5.05493 33.7218 31.1915 7.72328 25.1707 0.250012 +777 1 52.7526 32.6794 33.2917 -1.1678 -10.0217 7.16811 +778 2 52.3607 32.6823 34.7156 1.10255 -1.80451 -46.4405 +779 2 53.6298 32.9771 35.466 24.3124 -3.86391 3.03884 +780 3 54.7252 32.4235 35.2212 -23.0397 10.722 4.71956 +781 4 52.6718 31.7771 32.7765 -0.499018 10.5241 3.64804 +782 4 51.648 33.5318 34.8013 -6.43996 -0.39665 8.9378 +783 2 51.7643 31.3153 35.1205 -14.6608 -0.598675 31.299 +784 2 50.4472 31.4454 35.9643 8.77941 -15.5352 -26.1807 +785 2 50.5832 31.9625 37.3651 -2.67912 16.3525 37.5763 +786 3 49.9209 32.9494 37.7433 9.07957 -2.58057 -6.15032 +787 1 51.437 31.3297 38.2211 2.67596 1.57171 0.930055 +788 4 52.5216 30.7277 35.7054 -4.20254 0.0350677 -4.46682 +789 4 51.4878 30.6783 34.2719 3.29993 -4.42069 -15.0162 +790 4 49.9434 30.4567 35.9623 3.78404 -4.63917 10.5702 +791 4 49.6858 32.0412 35.427 2.21977 11.0074 -1.38139 +792 4 51.8063 30.3924 37.9705 2.16328 6.00798 1.3625 +793 4 51.6437 31.7399 39.1747 -6.68696 -10.5036 -22.3596 +794 1 53.5095 33.8962 36.42 -8.20166 25.4414 22.1973 +795 2 54.5747 34.3024 37.3295 -19.3274 -47.2338 19.7644 +796 2 54.3374 33.5175 38.6424 -52.3016 59.5202 -10.0971 +797 3 53.3688 33.7998 39.3891 18.863 -9.21915 -6.06634 +798 4 52.6243 34.4292 36.5865 8.7567 -9.68897 -5.69769 +799 4 0.524888 33.8606 36.995 20.2449 10.0463 -17.6441 +800 2 54.6326 35.7977 37.4305 -12.9517 47.1344 28.5316 +801 2 0.0326923 36.4499 36.0829 -2.43572 -2.53932 -10.8482 +802 2 0.0400304 37.9734 36.2703 -35.7369 26.7596 -9.32276 +803 2 1.42323 35.9178 35.6511 7.48175 21.564 37.2538 +804 4 0.37702 36.205 38.1946 -7.23177 -18.0499 -4.52301 +805 4 53.6103 36.1739 37.8346 22.3749 -7.86488 -15.795 +806 4 54.308 36.1878 35.2646 -5.73883 1.17112 4.65385 +807 4 54.1487 38.389 36.8719 12.989 -15.5349 -14.8375 +808 4 55.0091 38.5546 35.2982 1.66458 -12.2972 11.8538 +809 4 0.898146 38.314 36.8215 26.4509 7.27198 12.604 +810 4 1.38795 34.9003 35.2548 1.76467 -17.1685 3.06812 +811 4 2.15782 36.0461 36.5409 -11.2535 -11.763 -23.0993 +812 4 1.84494 36.4876 34.8385 7.70144 16.3511 -18.9114 +813 1 0.00368541 32.3928 38.6933 60.3495 -72.1401 -12.2197 +814 2 54.849 31.2911 39.6724 -12.054 11.0917 -33.5573 +815 2 0.456178 31.7903 40.9874 10.6429 2.84259 -7.8967 +816 3 1.61925 32.1816 41.0469 -1.25889 2.69502 -0.320895 +817 4 0.771148 32.2113 37.9508 -27.5595 2.34137 31.2634 +818 4 53.7516 31.0568 39.7052 4.35339 2.80588 13.4321 +819 2 0.572301 30.0297 39.0906 18.5839 -9.3637 1.30639 +820 2 0.330271 28.7129 39.848 -4.85336 -14.889 23.6916 +821 2 0.693398 28.6486 41.365 -25.7394 -2.5332 -16.7842 +822 3 54.7394 28.745 0.295995 1.88939 6.38348 7.55667 +823 3 1.88537 28.4667 41.718 12.1129 0.623711 3.73015 +824 4 1.68124 30.2872 39.0755 -12.926 -11.288 -1.20667 +825 4 0.269733 29.7427 38.025 4.32739 20.9521 12.5377 +826 4 0.909417 27.8521 39.409 -5.73579 9.2082 -7.491 +827 4 54.2152 28.4395 39.7334 16.9231 1.48772 2.1114 +828 1 54.6305 31.7883 0.132952 22.8608 6.07746 39.2243 +829 2 54.8576 32.3299 1.48573 -29.3221 31.1311 -21.4901 +830 2 1.17253 32.0229 2.2009 17.6366 -16.111 10.5973 +831 3 1.59057 32.8071 3.07156 -0.674056 0.0659302 -13.788 +832 4 53.659 31.6017 41.9208 -28.5726 -8.3455 -12.917 +833 4 54.8441 33.4787 1.30532 5.06012 -29.8204 14.0187 +834 2 53.6539 32.0394 2.47663 -0.820586 10.1398 -23.6755 +835 2 52.2239 32.3686 2.01123 21.8921 -9.62397 -13.268 +836 3 51.4302 33.0165 2.73635 3.85378 3.64717 10.9914 +837 3 51.8951 32.0293 0.84168 -3.94391 -2.23918 -4.0609 +838 4 53.7898 32.6162 3.39279 8.30271 4.42614 18.4259 +839 4 53.7249 30.9715 2.71423 -6.48233 -12.4206 11.3701 +840 1 1.80027 30.8157 2.00429 -3.41308 17.021 -11.1273 +841 2 3.01391 30.3872 2.67306 -17.4243 6.23421 51.1709 +842 2 4.3573 30.5827 2.00701 -14.1548 15.4243 -63.5733 +843 3 5.42088 30.6338 2.61698 6.51202 -0.211014 15.7475 +844 4 1.38736 30.0831 1.41283 -0.948729 3.54349 -2.60962 +845 4 3.08525 30.9412 3.69277 -1.85342 -9.762 -26.0847 +846 4 2.85031 29.3254 2.98975 11.9317 8.24793 -5.27874 +847 1 4.28888 30.743 0.620497 -12.3621 7.32386 22.4338 +848 2 5.32937 31.2764 41.6512 -13.8663 -29.5394 -9.66616 +849 2 5.57121 32.722 0.10225 -38.3787 16.5244 28.1783 +850 3 4.67744 33.4061 0.685107 26.0808 -18.0695 -15.0621 +851 4 3.36015 30.6914 0.159011 7.3551 0.286523 4.85155 +852 4 6.25759 30.6643 41.7722 1.97617 9.44883 5.82281 +853 2 4.84937 31.1813 40.1487 29.2597 0.863212 8.06821 +854 2 4.69879 29.8019 39.4857 10.4894 -21.0831 -13.1113 +855 2 5.6473 28.6668 39.9936 -13.3021 -14.9024 -16.8737 +856 1 5.27077 28.179 41.3306 -2.96519 4.49812 -11.7353 +857 2 6.06985 28.0105 0.470368 18.4061 -2.74343 27.4639 +858 1 7.404 28.2193 0.415809 -33.9112 -6.97322 0.0250223 +859 1 5.53751 27.6715 1.66745 7.41355 -4.5447 5.6764 +860 4 5.59287 31.7875 39.5584 -6.62026 -5.01092 -0.797873 +861 4 3.90042 31.6963 40.0361 -18.37 16.2558 -2.13315 +862 4 4.87993 29.9347 38.3602 -5.0628 -2.10161 17.6043 +863 4 3.66163 29.4121 39.5629 -5.01534 4.60088 1.06729 +864 4 6.67981 29.0441 39.9161 8.56645 -0.645935 3.00783 +865 4 5.57604 27.7587 39.2774 2.4211 23.1794 17.5601 +866 4 4.26853 28.0084 41.463 -5.17362 0.488763 -0.181308 +867 4 7.82192 28.2777 41.397 19.0269 3.46358 -1.03101 +868 4 7.9555 28.2212 1.28205 9.21585 -1.90571 -0.36079 +869 4 4.50489 27.4888 1.75639 19.7441 2.64647 4.92685 +870 4 6.15841 27.5559 2.53009 -21.7479 0.642981 -21.0512 +871 1 6.76075 33.214 41.6912 19.219 -12.8447 -16.8584 +872 2 7.12868 34.5749 41.8436 1.78261 35.3429 43.0116 +873 2 6.77609 35.3298 40.5962 -19.1975 -45.9981 -46.2181 +874 3 6.48326 34.7082 39.534 6.6414 26.9902 28.4778 +875 4 7.37626 32.7254 41.0127 -5.73863 2.32833 8.30529 +876 4 6.55071 35.0559 0.812315 8.37617 -12.7412 -20.2377 +877 2 8.6392 34.7953 0.238234 19.5739 7.90851 -48.6006 +878 3 9.35353 34.1854 41.0304 -12.8386 -4.95727 8.3137 +879 2 9.11551 34.1669 1.50873 -18.8724 -23.6236 42.9663 +880 4 8.9088 35.8955 0.234805 -6.25165 -9.40588 3.92441 +881 4 10.2786 34.3917 40.988 -0.40493 9.85267 11.4657 +882 4 10.1184 34.4515 1.79035 25.1513 6.04912 0.147779 +883 4 9.07131 33.0605 1.52977 2.37755 -2.72972 -9.56943 +884 4 8.50911 34.4369 2.41136 -0.948376 7.25744 -9.18832 +885 1 6.94474 36.6394 40.6556 -2.44135 26.6434 -23.8261 +886 2 6.9184 37.5467 39.5347 6.69905 -14.1713 -12.8446 +887 2 8.05389 37.1964 38.5245 -27.4859 18.9986 34.7956 +888 3 7.86013 37.2053 37.325 -9.29767 -2.30205 -27.2404 +889 4 7.0965 37.1097 41.5252 4.96112 6.67936 34.6112 +890 4 5.99819 37.3272 38.9586 -4.63141 4.06603 -3.57729 +891 2 6.96111 39.0217 40.0249 7.60343 4.99798 32.9439 +892 2 5.64771 39.5459 40.7503 13.3303 -11.7686 1.87571 +893 2 5.75985 41.0532 41.0609 20.2812 5.99168 -41.4278 +894 2 4.32816 39.2726 39.9704 18.565 3.35099 -29.4893 +895 4 7.21258 39.6788 39.2071 1.58444 12.8598 -26.2647 +896 4 7.87294 39.1662 40.7418 -24.807 -6.41168 -15.2883 +897 4 5.6203 39.0148 41.7319 -7.34537 -3.15131 1.25362 +898 4 4.91646 41.4032 41.6252 -26.0876 7.76092 9.54018 +899 4 5.84653 41.6805 40.0749 -1.44823 -14.0856 28.5036 +900 4 6.60816 41.2866 41.7276 9.52725 -0.69638 -3.08419 +901 4 4.29893 39.8385 38.99 0.215491 -3.12837 12.3269 +902 4 3.42741 39.5069 40.5265 -12.1672 8.54215 8.82184 +903 4 4.17367 38.2217 39.6869 7.24572 -5.84244 0.858739 +904 1 9.22626 36.8637 39.0427 21.4973 3.37181 48.1033 +905 2 10.3674 36.5714 38.2232 -9.10154 -9.23991 0.387697 +906 2 10.2983 35.2598 37.4643 -7.87493 -21.516 -1.82692 +907 3 11.0121 35.0941 36.4546 -10.096 5.18496 3.08952 +908 4 9.43559 37.0753 40.0799 -6.60045 -9.32212 -38.2223 +909 4 10.38 37.3229 37.4195 5.65865 10.6121 -8.5187 +910 2 11.637 36.6734 39.0312 17.5501 -7.37692 6.57672 +911 3 11.6795 35.7227 40.1079 -2.8679 20.1807 -0.19791 +912 4 11.748 37.6704 39.4409 -4.03165 17.0402 13.6797 +913 4 12.5247 36.6276 38.381 6.78129 -14.3562 -2.26856 +914 4 12.1944 34.9922 39.8075 10.5839 -13.8343 -8.97123 +915 1 9.37599 34.317 37.8723 17.0981 22.6825 36.4547 +916 2 9.03961 33.1663 37.0884 -21.5177 -32.5135 -8.8238 +917 2 8.42186 33.6216 35.772 12.1136 -61.8885 -37.6156 +918 3 8.46238 32.81 34.7849 1.32901 29.1307 35.9822 +919 4 8.95542 34.3811 38.853 10.4706 -4.46378 -29.0763 +920 4 9.93142 32.5518 36.7616 2.79547 16.9463 9.21372 +921 2 8.03197 32.1466 37.7484 3.42637 10.6841 -18.9321 +922 2 8.64707 31.2467 38.7916 -6.9544 1.67927 -4.64681 +923 3 8.29676 31.4213 39.9815 6.74685 -6.11142 9.13282 +924 3 9.44706 30.3423 38.4151 3.7337 3.36295 -6.87259 +925 4 7.50152 31.5448 36.9637 8.39997 -2.11551 6.41653 +926 4 7.19405 32.7023 38.1775 -8.25993 10.1263 10.5291 +927 1 7.75009 34.762 35.719 -22.4701 19.7147 -23.1057 +928 2 7.04455 35.3131 34.5484 -10.1936 -29.3849 23.8741 +929 2 7.86233 36.3488 33.8376 -13.0656 11.1044 -41.9487 +930 3 7.58485 36.6599 32.6528 -2.0293 -9.17756 21.4272 +931 4 7.63327 35.3235 36.5488 -2.91413 9.03335 17.0933 +932 4 6.86396 34.4501 33.8456 12.5342 10.3996 -5.08052 +933 2 5.61426 35.844 34.9306 19.6262 -1.52617 -28.8748 +934 2 4.83213 34.6653 35.4025 -10.2806 -24.7237 17.6593 +935 2 4.57558 34.457 36.7787 11.017 23.715 -9.65022 +936 2 4.42364 33.669 34.4835 -0.204454 17.9401 5.69744 +937 2 3.80293 33.3928 37.1817 -18.0339 -16.5573 23.9014 +938 2 3.6203 32.6104 34.8697 -1.59657 -1.57291 16.7967 +939 2 3.28719 32.4878 36.2185 14.3191 25.239 16.785 +940 3 2.42643 31.5967 36.7004 -21.786 -29.0921 6.36516 +941 4 5.08947 36.2348 33.9913 8.47084 3.13833 18.0937 +942 4 5.68856 36.6154 35.7126 -3.45102 11.3715 1.65586 +943 4 4.93536 35.177 37.5545 -2.85956 -5.82375 -8.46254 +944 4 4.68581 33.7849 33.4351 -1.13786 -0.0334624 -10.731 +945 4 3.5508 33.3312 38.3093 3.7661 -3.16504 -32.8067 +946 4 3.21561 31.8879 34.1609 -1.14089 -4.88721 -7.16666 +947 4 2.07822 31.0058 36.0335 4.80509 5.07869 -1.12919 +948 1 8.89276 36.9109 34.4697 3.08208 2.61779 2.42454 +949 2 9.71554 37.9518 33.9536 6.78836 41.9101 -7.41895 +950 2 8.87118 39.1918 33.5791 -2.83098 -3.29658 16.5328 +951 3 9.07345 39.7706 32.5156 6.00915 0.294316 2.75033 +952 4 9.0886 36.6939 35.4314 3.3626 -5.13227 22.9354 +953 4 10.4005 38.393 34.7625 -11.752 -18.5108 -5.62727 +954 2 10.5665 37.5273 32.7526 17.9231 -22.0125 -23.4044 +955 2 11.7038 38.502 32.4536 -20.96 9.74481 -37.2535 +956 3 11.6878 39.1949 31.3977 0.540028 -8.54016 25.273 +957 1 12.687 38.5377 33.3475 38.0496 20.2334 23.5086 +958 4 9.97947 37.4403 31.7814 1.01798 2.165 18.3599 +959 4 11.0193 36.505 32.8955 -2.74071 8.1052 0.988861 +960 4 12.6531 37.864 34.1655 7.32082 17.5294 -13.3715 +961 4 13.4532 39.3055 33.2787 -30.6572 -33.7139 4.421 +962 1 7.93658 39.5767 34.4996 32.6534 -23.6413 -9.43678 +963 2 7.20273 40.8089 34.5743 -2.74612 21.1773 -15.346 +964 2 8.21766 41.8982 34.9197 -3.45605 -13.7782 10.2915 +965 3 8.98784 41.7778 35.8832 -3.40272 -3.46005 -6.10842 +966 4 7.93188 38.9898 35.3424 -7.46187 6.56739 7.86278 +967 4 6.79415 41.087 33.5295 1.97546 -9.26453 20.6229 +968 2 6.06472 40.6271 35.6481 -5.08297 -2.08213 -22.9213 +969 2 4.90833 39.9858 34.8157 -12.6977 -10.7104 -3.72739 +970 2 5.64222 41.9226 36.403 -2.05312 -2.0705 -19.9517 +971 2 3.84054 39.2603 35.6406 -0.0147652 -3.33058 30.6695 +972 4 6.3943 39.8459 36.3734 2.85979 7.06395 10.3389 +973 4 5.33061 39.1839 34.1245 -4.62997 12.2623 4.99778 +974 4 4.37584 40.73 34.1591 8.26763 -2.20969 2.2716 +975 4 4.92993 41.6478 37.2106 -0.0042749 6.0371 4.19307 +976 4 5.15795 0.778755 35.7389 -1.27911 -10.984 2.34352 +977 4 6.51935 0.549814 36.8166 0.412823 -4.00159 10.9885 +978 4 3.21428 39.9846 36.2492 8.55414 -9.22464 -7.99451 +979 4 4.28582 38.4972 36.3757 -6.36125 15.4526 -14.7269 +980 4 3.14756 38.696 34.9847 -1.95473 -0.292674 -1.44435 +981 1 8.25206 1.08297 34.1638 31.3741 38.5442 9.59718 +982 2 9.18814 2.19093 34.4552 -11.7272 -14.356 -0.722089 +983 2 8.45749 3.48131 34.8023 4.76941 7.21795 3.77261 +984 3 7.24176 3.59586 34.6101 4.23254 1.41941 3.46139 +985 4 7.75397 1.25241 33.3001 -16.6469 -12.6897 -14.3012 +986 4 9.75614 1.90919 35.3591 7.11639 4.99627 7.91164 +987 2 10.1452 2.40125 33.2642 -9.36205 3.53781 1.41258 +988 2 11.145 1.26701 33.0621 15.3724 -18.5317 -10.2549 +989 2 12.3408 1.2215 34.0193 -34.6799 -20.8737 -4.25674 +990 3 13.4283 1.6066 33.6334 28.2263 9.73281 -4.88467 +991 1 12.1185 0.540183 35.1633 28.8031 2.35628 29.4382 +992 4 10.7148 3.34616 33.3936 1.59432 0.534457 -2.79864 +993 4 9.49714 2.55965 32.3759 6.01649 -0.268224 -5.10448 +994 4 11.6127 1.34439 32.0577 -0.769775 9.57011 -1.56393 +995 4 10.6933 0.251936 32.9886 -5.52334 3.35231 7.85959 +996 4 11.2139 0.219277 35.5156 -12.526 -0.0546681 -6.86711 +997 4 12.9016 0.455342 35.8573 -9.00019 3.15098 -17.6728 +998 1 9.24699 4.48326 35.2867 7.50516 -22.9453 -9.87373 +999 2 8.79457 5.81029 35.6553 19.4094 -0.44208 23.4194 +1000 2 7.94193 6.35186 34.5098 -28.0836 13.7832 22.6841 +1001 3 8.26577 6.15625 33.3485 3.32417 -1.59684 -17.5239 +1002 4 10.2626 4.25405 35.3107 -8.01304 16.2193 5.9612 +1003 4 8.1894 5.68577 36.5846 -11.6257 -0.00282829 -7.04897 +1004 2 9.97767 6.74716 36.1433 -23.7266 14.1696 -20.2452 +1005 2 11.1395 6.93836 35.1562 2.17384 -4.68321 -25.171 +1006 2 12.442 7.40754 35.8023 6.89417 23.6707 25.6501 +1007 2 12.3585 8.87197 36.3546 -17.7601 7.18701 6.16378 +1008 1 13.652 9.40345 36.7619 -5.05233 -10.0697 25.3038 +1009 4 10.4674 6.41708 37.0624 -6.17454 -12.8958 16.6295 +1010 4 9.46609 7.72624 36.4439 19.6997 -12.4825 -9.52898 +1011 4 10.8586 7.67723 34.3661 -2.31205 -2.27426 2.47252 +1012 4 11.3956 5.98923 34.5935 -8.15618 9.36142 7.97067 +1013 4 13.285 7.3766 35.0989 4.02069 -2.74272 -14.2107 +1014 4 12.7725 6.74228 36.6382 -4.94702 -0.810609 -4.3443 +1015 4 11.6162 8.97546 37.2517 21.5709 -5.37851 -23.6156 +1016 4 11.9848 9.59279 35.5592 1.32622 -13.234 7.43529 +1017 4 13.5097 10.3531 37.0548 1.1249 12.5728 4.15723 +1018 4 14.3076 9.4933 35.9914 2.38442 -5.54985 1.16984 +1019 4 14.0989 8.9471 37.5942 -8.28554 10.0467 -28.7492 +1020 1 6.74258 6.95961 34.8453 13.8439 -7.08515 -31.5666 +1021 2 5.70412 7.47847 33.9372 22.4359 17.1833 28.8896 +1022 2 4.73468 6.47268 33.3926 -37.2702 -51.3286 -21.7325 +1023 3 3.66084 6.82477 32.8505 20.0183 9.28716 8.38675 +1024 4 6.50761 7.12516 35.8163 -0.959582 1.3178 20.8718 +1025 4 5.07512 8.17388 34.5809 1.06569 -12.1955 -8.24357 +1026 2 6.27511 8.35576 32.8097 23.4106 2.51452 -13.5767 +1027 2 6.97942 9.67377 33.2004 -16.9954 14.0421 10.4255 +1028 2 6.10535 10.8129 33.826 12.866 -26.3315 -27.4761 +1029 3 5.32563 11.4369 33.048 -2.57309 4.89094 -0.177716 +1030 3 6.28787 11.1355 35.0235 5.56298 3.82152 16.5631 +1031 4 5.49496 8.55729 32.0786 -16.2509 9.70978 -5.42728 +1032 4 7.00993 7.79082 32.1666 -6.62982 -1.98309 13.432 +1033 4 7.44051 10.1227 32.2823 5.63402 -3.39012 2.91122 +1034 4 7.79617 9.4262 33.9151 4.88029 0.56984 -5.69246 +1035 1 4.9985 5.11713 33.407 24.659 21.8647 21.6253 +1036 2 4.05493 4.11234 32.9569 -19.5991 11.2557 -30.6753 +1037 2 2.66349 4.36425 33.564 5.77052 11.5327 33.941 +1038 3 2.61183 4.63212 34.7889 -10.6254 -2.1096 -24.9185 +1039 4 5.90798 4.72579 33.7623 -18.8375 16.0079 -6.75199 +1040 4 3.94963 4.2178 31.8123 4.18537 -9.18741 21.4869 +1041 2 4.52113 2.73738 33.4375 8.25229 -17.2331 29.0433 +1042 3 5.75234 2.38881 32.7881 -21.5054 -2.62865 -12.7372 +1043 4 3.76903 1.95227 33.2696 -3.85539 -5.9091 -13.5606 +1044 4 4.62925 2.69715 34.589 6.20333 6.93314 -25.3828 +1045 4 6.43526 2.61043 33.3995 7.46021 4.72267 11.925 +1046 1 1.55191 4.21884 32.8032 -14.0425 -5.15851 -21.6842 +1047 2 0.161375 4.25438 33.2368 -9.40026 13.4655 23.096 +1048 2 54.692 2.80115 33.3646 18.1492 -1.83923 -37.1888 +1049 3 54.7885 2.04564 32.3679 -9.76904 2.34815 11.9713 +1050 4 1.58614 3.87283 31.8209 11.2241 6.42129 12.946 +1051 4 0.0932821 4.78062 34.2407 6.57702 -9.00044 -6.29593 +1052 2 54.1421 5.03026 32.3092 -30.8516 -27.3257 32.8914 +1053 3 54.4529 6.38645 32.3432 43.6526 11.7784 12.1317 +1054 2 52.6693 5.00292 32.8811 18.0931 2.75777 -15.9968 +1055 4 54.1554 4.62002 31.3044 4.18983 -2.87474 -22.2473 +1056 4 53.8639 6.90955 31.8518 -25.2917 13.9269 -18.693 +1057 4 52.66 5.46781 33.8932 -7.48107 5.39969 -2.18241 +1058 4 52.249 3.98991 33.0062 0.231344 -5.48034 -3.27193 +1059 4 51.9963 5.5356 32.1423 1.66512 -1.40627 14.088 +1060 1 54.1705 2.41097 34.5199 1.80418 26.5965 31.5441 +1061 2 53.4771 1.1604 34.7223 -23.5881 -17.4143 30.2256 +1062 2 51.9672 1.43692 34.4286 45.4706 11.6959 19.6168 +1063 3 51.5098 2.51334 34.8139 -14.0548 -1.70012 -4.22959 +1064 4 54.1449 3.13072 35.3168 -2.84084 -28.6208 -21.3152 +1065 4 53.8073 0.317305 34.0552 7.54144 10.0832 -0.542806 +1066 2 53.6466 0.727247 36.2732 15.0023 -0.977243 -19.0787 +1067 2 0.11045 0.778115 36.8855 -3.47233 23.3808 -12.4462 +1068 2 0.174657 0.0352411 38.2454 9.71436 -6.65086 -1.81426 +1069 2 1.19132 0.222888 35.8995 6.11034 15.7938 3.95568 +1070 4 53.2393 41.6189 36.352 -4.11551 -11.0062 3.39296 +1071 4 53.0266 1.35722 36.9407 -10.5209 2.31976 -3.99924 +1072 4 0.276909 1.89779 37.0745 11.3679 -17.77 -1.06189 +1073 4 54.361 0.442618 38.9125 4.10216 -8.97134 2.26246 +1074 4 1.16474 0.174268 38.7716 -10.2453 4.64912 -5.91146 +1075 4 0.0894693 40.827 38.1128 -8.07449 10.5575 2.47406 +1076 4 2.18017 0.0911741 36.3628 0.498668 -8.86502 15.8712 +1077 4 1.51082 0.946112 35.1046 -21.6742 -5.82018 -4.77892 +1078 4 0.87048 41.1455 35.5035 3.84873 -0.316194 -7.96637 +1079 1 51.2572 0.510776 33.7869 -35.0849 -22.21 -18.422 +1080 2 49.7991 0.651464 33.5457 -7.89552 -1.42073 2.85742 +1081 2 49.1064 41.7127 34.6422 20.8091 24.7993 -30.4476 +1082 3 49.3211 40.5176 34.6928 0.936017 -16.9834 6.81615 +1083 4 51.5685 41.4333 33.6514 6.90564 11.6478 3.53197 +1084 4 49.4699 1.73569 33.6536 7.71362 -9.58165 1.5915 +1085 2 49.2914 0.124722 32.1435 -1.6477 0.542595 21.3952 +1086 2 49.5957 1.07684 31.016 -40.6033 -15.585 26.437 +1087 1 48.7294 1.99918 30.4836 -27.6566 13.4748 -4.54446 +1088 2 50.7297 1.21695 30.3262 36.7247 10.1326 -33.1818 +1089 2 49.2902 2.59089 29.4013 15.6758 12.8861 -16.3634 +1090 1 50.5605 2.13547 29.3267 -27.6128 -3.77706 23.4645 +1091 4 48.1729 41.8384 32.2733 14.3125 6.04861 -12.1255 +1092 4 49.7214 41.0254 31.9181 -0.443629 4.48635 2.11286 +1093 4 47.7408 2.2006 30.8029 20.1006 -6.4749 -2.25561 +1094 4 51.6449 0.698065 30.4056 15.084 -12.5894 5.57169 +1095 4 48.9104 3.2954 28.6425 -5.47018 -10.6135 19.6435 +1096 4 51.2563 2.40703 28.6421 12.9903 7.46191 -13.5301 +1097 1 48.3611 0.457254 35.523 -13.4783 35.8963 4.98689 +1098 2 47.6684 41.7265 36.6028 -12.609 2.82517 16.7739 +1099 2 46.2613 41.336 36.1362 14.2498 9.86212 -6.63619 +1100 3 45.3696 0.249228 35.9008 11.2544 -8.11188 8.40093 +1101 4 48.1527 1.47601 35.3837 2.04907 -15.0615 5.33592 +1102 4 48.2568 40.8085 36.8471 -2.89667 -2.02658 5.80089 +1103 2 47.5596 0.692305 37.8969 5.07609 12.8861 -15.4572 +1104 2 46.7247 0.067171 39.0652 -23.3887 -7.36646 -24.3057 +1105 2 47.033 40.4837 39.4166 -14.2982 16.8046 -18.6717 +1106 2 46.9311 0.907751 40.3269 20.2628 20.9695 31.7148 +1107 4 47.0803 1.72619 37.5586 18.4264 -28.4903 17.3716 +1108 4 48.6288 0.838001 38.2574 -15.841 5.68773 -4.62102 +1109 4 45.6307 0.107149 38.6982 15.4635 0.946246 17.2142 +1110 4 48.0197 40.3992 39.8616 17.8935 -6.94949 10.1905 +1111 4 47.0012 39.8155 38.524 1.84183 3.03864 3.36861 +1112 4 46.2605 40.0937 40.1174 3.5183 -0.242765 2.2201 +1113 4 48.0596 1.05972 40.5786 -27.9597 -7.64804 -5.61245 +1114 4 46.4366 0.492644 41.2461 4.13191 -4.52617 -8.48469 +1115 4 46.5029 1.93558 40.2678 1.33797 -2.98423 -8.86627 +1116 1 46.1363 40.0225 35.9719 -11.8784 -48.163 0.632693 +1117 2 44.9067 39.2611 35.7716 22.3959 0.0668878 -14.2888 +1118 2 44.4049 38.8629 37.1725 -35.2322 11.6067 -22.5418 +1119 3 45.1472 38.486 38.0617 14.0918 -2.68919 9.70234 +1120 4 46.908 39.3425 36.1226 1.34088 13.782 2.29065 +1121 4 44.2497 39.8817 35.1331 -17.245 4.97255 12.4072 +1122 2 45.2366 37.985 34.8925 -4.99104 -6.23114 -9.17669 +1123 2 44.0069 37.0072 34.8313 5.26574 11.342 7.98842 +1124 2 45.6195 38.3915 33.4226 -3.76358 -20.0352 6.70883 +1125 4 46.1177 37.4383 35.3134 -3.76426 -1.15462 7.05426 +1126 4 43.5316 36.9313 35.8696 0.358942 -6.34703 -24.4349 +1127 4 44.3242 35.9956 34.5249 4.20531 -7.16171 2.34616 +1128 4 43.2753 37.3126 34.0403 -3.87397 3.42825 10.5933 +1129 4 46.6384 38.8467 33.4221 -3.79452 2.69366 -2.61982 +1130 4 44.9004 39.1304 33.0043 0.823619 -0.608417 -3.73086 +1131 4 45.6564 37.4663 32.7381 0.0287792 19.4258 11.3413 +1132 1 43.0561 38.9062 37.36 16.7964 -0.846157 38.4014 +1133 2 42.4272 38.5172 38.6279 -14.5421 -18.7427 13.0828 +1134 2 41.8753 37.0763 38.5124 -8.78692 12.5845 -64.2445 +1135 3 41.466 36.6885 37.3717 6.29707 6.96761 32.6735 +1136 4 42.3774 39.0214 36.6331 -15.2734 7.16413 -28.2079 +1137 4 43.1919 38.4467 39.4108 16.1917 0.0561369 8.47296 +1138 2 41.3404 39.5151 39.1514 -18.2527 2.1619 5.40726 +1139 2 42.0205 40.8503 39.6333 -29.5812 13.2835 -20.5362 +1140 2 41.0689 0.171231 39.4112 30.2059 17.4331 -9.29433 +1141 2 42.4678 40.816 41.1078 15.9246 -23.8206 -10.1516 +1142 4 40.688 39.0893 39.9799 16.7303 0.907162 -6.07322 +1143 4 40.5588 39.6983 38.3606 15.4269 0.857054 0.728379 +1144 4 42.8535 41.0549 38.9416 17.5291 -0.3509 1.61726 +1145 4 41.6271 1.1561 39.6676 -14.9721 -22.7636 -0.520954 +1146 4 40.1564 0.111331 40.0029 -13.6089 -0.269988 10.9836 +1147 4 40.76 0.320829 38.3386 1.94315 -8.64923 8.74761 +1148 4 41.6626 40.4848 41.7802 -9.99726 5.60483 6.07701 +1149 4 42.8258 41.8281 41.4135 4.90552 -5.57863 6.49728 +1150 4 43.2679 40.0127 41.241 -4.54696 19.1865 -0.92221 +1151 1 41.8233 36.2733 39.5754 -3.61756 -11.0936 16.9633 +1152 2 41.1922 34.957 39.6399 -10.4088 -17.6704 -50.7121 +1153 2 39.8412 35.0841 40.3193 -0.437683 4.39576 10.763 +1154 3 39.8144 35.4746 41.4864 -9.76 5.96233 -2.547 +1155 4 42.2323 36.5766 40.4577 6.86651 4.46574 10.4638 +1156 4 40.9934 34.6386 38.4963 8.65196 -1.15376 42.0164 +1157 2 42.0562 33.8903 40.4247 20.8855 33.0106 -9.02378 +1158 2 41.3005 32.6543 41 38.0556 15.2529 -12.1112 +1159 2 42.2217 31.3951 41.1067 -29.8496 -30.3433 -13.4218 +1160 1 43.3285 31.549 0.111927 13.7517 39.8644 23.5527 +1161 2 44.3839 30.7268 0.286736 21.6234 19.2182 17.9174 +1162 1 44.681 29.6113 41.5428 -25.8767 -16.3024 -25.7307 +1163 1 45.3493 31.1499 1.13058 -39.3833 23.49 -6.35183 +1164 4 42.617 34.5166 41.192 -12.3652 -23.3828 3.531 +1165 4 42.8948 33.5841 39.7601 -4.64767 -6.80459 -5.17496 +1166 4 40.4819 32.4474 40.3056 -13.8786 -11.9041 -4.8646 +1167 4 40.8645 32.9834 0.0421702 -8.7777 -8.2778 13.4879 +1168 4 42.5872 31.067 40.0872 -0.36901 12.0823 9.30135 +1169 4 41.553 30.5032 41.4129 16.6518 20.7036 2.18161 +1170 4 43.3615 32.497 0.627799 -1.11121 -36.4642 -14.6418 +1171 4 44.0326 29.3067 40.7749 11.9664 -0.606259 12.9296 +1172 4 45.4908 28.9966 41.7635 -4.5997 7.04477 0.652143 +1173 4 45.2947 32.0222 1.6989 -3.32167 -9.1207 -8.17541 +1174 4 46.1369 30.5772 1.3332 29.28 -20.6173 7.21336 +1175 1 38.7318 34.7203 39.6307 -5.56998 -4.40152 -32.2775 +1176 2 37.3555 34.7738 40.1542 17.1032 1.0045 -6.37855 +1177 2 37.2353 33.667 41.1913 -33.3614 37.0741 40.0449 +1178 3 37.7005 32.5636 40.9891 18.731 -32.0974 -3.65368 +1179 4 38.8335 34.3404 38.6486 -6.51334 12.5121 23.5529 +1180 4 37.2672 35.7762 40.6273 -9.086 1.46109 5.84779 +1181 2 36.2453 34.5638 39.0845 -6.93832 -9.37108 -7.97374 +1182 2 36.1701 35.614 37.9414 8.91404 15.2365 -6.3275 +1183 2 35.3527 35.0344 36.7472 39.8054 8.21108 -27.9 +1184 2 35.4841 36.9314 38.4139 -18.287 13.7727 -16.8718 +1185 4 35.232 34.5024 39.5744 7.45292 -0.257102 0.0904576 +1186 4 36.3852 33.5433 38.6164 0.781265 7.17557 6.89015 +1187 4 37.2115 35.9047 37.5843 -11.2451 -10.8797 5.10717 +1188 4 35.5662 35.6385 35.778 -16.1675 -5.48794 25.897 +1189 4 34.291 34.967 37.0013 -15.7304 -0.876038 -4.35202 +1190 4 35.7074 34.0135 36.4456 -4.10332 3.28733 9.08934 +1191 4 35.4655 37.7439 37.5577 -4.97646 -27.0735 23.6494 +1192 4 36.0148 37.4196 39.237 12.1669 1.46201 8.99598 +1193 4 34.4369 36.7462 38.8365 16.8945 3.16641 -16.172 +1194 1 36.5334 33.9935 0.435925 10.1465 7.38421 -15.9691 +1195 2 36.4058 33.2568 1.6875 16.4821 -29.3274 -13.0782 +1196 2 35.1468 33.6833 2.42741 -3.52585 26.4938 2.22063 +1197 3 34.7699 34.8785 2.50349 9.50092 -20.8144 -9.83338 +1198 4 35.9506 34.8486 0.439937 7.33038 -6.12466 -5.51472 +1199 4 36.3499 32.1247 1.42412 1.62075 26.2077 7.36918 +1200 2 37.675 33.5505 2.58336 -0.681506 -6.35683 7.58589 +1201 2 37.7854 32.6927 3.8625 18.6921 -17.668 32.0141 +1202 2 39.0575 32.9332 4.76873 14.2724 -20.5826 -30.9069 +1203 1 39.1289 34.2491 5.33109 11.0713 19.2422 13.5273 +1204 2 40.0441 34.6938 6.2528 -38.5124 5.77538 -21.346 +1205 1 41.0523 34.0015 6.75388 -9.3068 -30.315 -40.8639 +1206 1 39.7573 35.8959 6.75045 4.65044 -37.6482 -19.533 +1207 4 37.7117 34.6025 2.94212 -4.78803 6.98284 -11.1897 +1208 4 38.6033 33.3783 1.98429 -1.50456 2.19712 -0.683264 +1209 4 37.8193 31.5994 3.65006 -4.42508 0.799529 -11.9295 +1210 4 36.9318 32.7949 4.56147 -11.5542 5.52665 -5.70323 +1211 4 39.9727 32.6563 4.13477 -10.3426 12.9457 13.0222 +1212 4 39.0991 32.232 5.62646 -6.41615 -9.9444 -1.6393 +1213 4 38.3112 34.8566 5.12728 9.08197 -0.1797 3.06874 +1214 4 41.338 33.0965 6.26824 1.29043 26.2885 21.8424 +1215 4 41.5567 34.3995 7.53172 18.6054 -2.34736 15.9895 +1216 4 38.9283 36.4191 6.51463 -17.6749 8.57537 -7.4588 +1217 4 40.3535 36.2619 7.44459 24.2502 25.7988 36.1589 +1218 1 34.4423 32.7029 2.99518 -5.91218 -18.2551 8.17758 +1219 2 33.2643 32.9205 3.78866 2.14491 3.18155 15.0212 +1220 2 32.3114 31.74 3.93685 27.6029 1.93064 -50.2862 +1221 3 31.6521 31.6162 4.95167 -20.1995 -6.42992 23.3772 +1222 4 34.7506 31.7123 2.9878 2.11082 4.57648 -1.08475 +1223 4 33.5885 33.2179 4.82725 -4.56531 -3.45872 -11.3922 +1224 4 32.6993 33.791 3.40271 -6.19117 1.50996 -1.33542 +1225 1 32.2733 30.8792 2.86255 -3.44833 -0.807911 26.2314 +1226 2 31.5067 29.6456 2.87911 -22.6819 -12.0155 6.38652 +1227 2 32.0275 28.5204 1.99364 -17.4826 -15.7648 -26.1521 +1228 3 31.24 27.9052 1.1757 18.2868 13.9435 17.0259 +1229 4 32.9257 31.0189 2.07167 -6.99587 -10.4877 -2.31778 +1230 4 31.4409 29.1882 3.92659 1.7726 14.0477 -11.6562 +1231 4 30.4172 29.8482 2.57519 20.7941 0.876843 7.98191 +1232 3 33.2432 28.1769 2.02662 6.75216 10.2675 5.6015 +1233 6 29.6689 33.0345 2.6027 6.39732 3.7635 -6.59735 +1234 4 28.7656 33.0857 2.95028 -0.371973 -14.4593 -6.85361 +1235 4 29.8153 32.1814 2.14015 -8.59972 11.6466 4.8732 +1236 6 1.91326 24.7635 28.0772 5.65317 -6.35183 16.4854 +1237 4 1.01929 24.4316 28.2568 3.94453 1.46201 -0.938269 +1238 4 2.46517 24.4471 28.8255 -6.59296 2.11781 -11.8027 +1239 6 8.98979 35.4216 7.06427 2.13264 0.908259 -3.07356 +1240 4 8.22375 36.0041 6.95701 -0.608539 -3.26387 0.365744 +1241 4 9.74616 35.991 6.87666 4.70766 2.91314 -0.442423 +1242 6 37.9357 35.2342 23.5273 -23.102 9.18642 19.8247 +1243 4 37.5041 35.2968 22.6705 0.513901 -3.82007 -8.89977 +1244 4 38.8432 35.0218 23.4038 20.8563 -8.17935 -11.4372 +1245 6 11.3793 34.6137 20.3253 14.1507 4.32837 -4.20952 +1246 4 10.4755 34.624 20.6003 -22.0831 6.77293 1.73618 +1247 4 11.7264 33.9016 20.8561 13.9299 -11.0914 4.04985 +1248 6 3.06607 13.1144 13.5167 22.577 18.8722 18.6067 +1249 4 2.20388 12.8262 13.8046 -7.02328 -4.57126 0.810516 +1250 4 3.32154 13.8092 14.1761 -2.44089 -14.0351 -15.8923 +1251 6 9.17443 22.3777 24.8954 -7.42914 3.56866 8.74917 +1252 4 9.07626 22.0242 24.0039 2.26474 -2.4656 -3.7019 +1253 4 8.26912 22.4958 25.2295 3.15193 -1.43545 -3.27774 +1254 6 31.1464 36.1236 7.45234 10.6607 -18.1227 -24.2194 +1255 4 30.9334 35.2222 7.12747 -5.34615 12.6105 12.538 +1256 4 31.8314 36.3443 6.79825 -5.43643 8.62165 8.26122 +1257 6 20.3227 0.172698 30.1419 10.3105 -3.05703 7.76208 +1258 4 20.0388 1.0684 29.8874 5.3247 -3.32009 0.781739 +1259 4 21.2583 0.228399 30.4322 -11.2768 6.47679 -5.28094 +1260 6 32.6859 3.01778 5.15829 -10.6028 -19.0303 43.6625 +1261 4 32.0356 2.3058 5.02019 7.54008 9.83835 -8.28794 +1262 4 32.7128 3.00557 6.15578 5.12118 6.62375 -23.7252 +1263 6 26.2374 8.27856 11.5971 17.869 0.788073 20.0593 +1264 4 26.2346 7.39991 12.0216 -0.142457 7.42091 -4.28305 +1265 4 26.8978 8.79254 12.1302 -17.5189 -15.6641 -18.5798 +1266 6 1.09614 20.2561 0.875192 -22.9747 0.467748 19.1373 +1267 4 0.851949 19.3199 1.10255 19.4844 20.3298 -11.3195 +1268 4 1.85437 20.3448 0.297385 12.1513 -16.76 -9.59627 +1269 6 29.1514 22.9126 1.42851 -3.57267 15.5796 12.2113 +1270 4 28.6966 23.7416 1.67141 5.52941 -12.1705 -9.88265 +1271 4 29.6634 22.7027 2.22543 0.165437 -2.26551 -2.85175 +1272 6 34.1399 34.826 6.47271 -4.00425 12.5535 -7.93856 +1273 4 34.8635 34.3401 6.10458 13.259 -3.54932 -9.87122 +1274 4 33.9387 34.3337 7.25184 -8.28913 -2.66912 16.7304 +1275 6 25.1643 37.1931 26.5228 17.2229 -22.0393 -23.1844 +1276 4 24.6935 37.7676 27.1042 -4.31343 22.2846 18.4719 +1277 4 26.0117 37.6203 26.271 -7.79876 5.52479 6.28113 +1278 6 14.5333 22.2337 15.6719 -21.8235 -40.5779 4.16881 +1279 4 14.0435 21.3187 15.7268 23.5152 50.9834 -4.51283 +1280 4 14.2451 22.7392 14.8947 -1.224 -10.8945 3.63574 +1281 6 2.86145 5.86342 4.09514 -12.0928 12.5672 -7.55007 +1282 4 3.31871 5.53612 4.87755 -0.114002 3.3263 11.1441 +1283 4 2.36891 6.69134 4.30817 11.5092 -15.7361 4.93451 +1284 6 27.6072 26.7133 22.7037 11.3111 -21.4893 35.9413 +1285 4 26.8221 26.1673 22.7712 -7.10606 -4.70529 -2.97044 +1286 4 27.5145 27.2572 21.9514 -10.0855 20.8317 -32.7258 +1287 6 17.7799 0.609907 22.4001 -5.17757 10.6635 4.04288 +1288 4 17.0763 0.657064 23.0885 11.5181 4.04392 -9.91171 +1289 4 18.0806 1.5364 22.261 -7.85301 -10.5281 2.59652 +1290 6 8.08893 9.42761 10.5595 3.55537 5.25916 40.324 +1291 4 7.89361 10.322 10.3179 -9.19974 15.7377 -19.3495 +1292 4 8.16563 9.56196 11.5399 2.2102 -21.2534 -20.7584 +1293 6 15.3508 8.71886 30.755 5.09068 -14.416 21.7005 +1294 4 15.721 8.98141 29.9127 -5.17651 10.4904 -11.2194 +1295 4 14.5411 9.19598 30.997 6.64715 3.62724 -9.30987 +1296 6 11.0273 17.2714 37.5546 -8.62993 4.63856 -3.16721 +1297 4 10.646 18.1523 37.5049 13.3861 11.3255 -4.88271 +1298 4 10.2437 16.8378 37.8681 -2.55755 -24.0409 7.53141 +1299 6 42.0954 25.1585 20.3881 14.6842 1.84925 -24.6227 +1300 4 41.6997 25.8318 19.7943 -2.16553 -3.48259 16.6789 +1301 4 41.6994 25.1952 21.2528 -9.02961 7.39914 10.888 +1302 6 25.8656 4.70522 33.8434 4.94337 -17.9304 30.0995 +1303 4 25.7948 4.41246 32.9437 -1.56424 4.53154 -20.9619 +1304 4 25.7821 5.65919 33.9019 -2.93726 10.638 -9.31877 +1305 6 28.7565 10.7943 24.343 5.31048 -5.66707 -17.5237 +1306 4 29.0395 10.691 25.2776 6.61806 -8.7001 -20.887 +1307 4 29.3174 10.2678 23.7025 -8.86987 6.64124 26.5787 +1308 6 5.00601 41.813 11.1 6.11697 -35.3303 28.6791 +1309 4 5.97939 41.6679 11.0741 -12.7816 8.03831 -2.02432 +1310 4 4.68345 41.1078 11.7429 5.5471 25.1349 -25.8779 +1311 6 51.7607 12.785 30.1531 41.9873 7.8243 6.58168 +1312 4 51.5044 13.1989 29.3224 -3.76645 3.26875 -7.63234 +1313 4 52.7548 12.9452 30.2104 -29.821 -7.22149 1.35463 +1314 6 7.60527 6.19156 6.53697 16.5093 0.883216 -0.386471 +1315 4 6.7728 6.50088 6.91441 -4.77803 -9.70632 -1.71599 +1316 4 7.48617 5.31021 6.15237 -11.2115 3.19853 1.4886 +1317 6 14.6639 26.9856 30.1439 5.75321 15.8705 11.2484 +1318 4 14.5566 27.0259 31.1175 -3.12227 -7.05885 -13.9758 +1319 4 15.1715 27.7926 29.9326 -6.11328 -7.83436 0.701957 +1320 6 15.3386 3.73742 21.1629 -49.5233 -4.42818 1.41573 +1321 4 14.7513 4.15862 21.8308 22.5595 -2.74077 -5.2282 +1322 4 14.679 3.20837 20.6508 28.7222 9.19721 3.95726 +1323 6 18.6168 30.4391 6.46727 22.6827 -23.6706 30.2016 +1324 4 19.0357 29.7477 7.08277 -19.2097 26.0479 -21.7287 +1325 4 19.3376 31.0911 6.37388 -10.7119 -2.89972 -1.77141 +1326 6 40.7683 1.30949 12.8061 -7.58564 4.37034 -9.51004 +1327 4 39.8743 1.70123 12.8539 8.02325 -2.8267 0.614513 +1328 4 41.1302 1.62292 11.9594 1.79027 -4.37486 1.66609 +1329 6 17.747 20.7401 41.5828 -14.5708 23.9699 -22.25 +1330 4 16.8287 21.1121 41.5273 18.852 -12.8662 8.2158 +1331 4 18.269 21.3043 40.983 -0.296974 -7.34806 11.4382 +1332 6 20.4522 2.1467 12.3338 -13.8993 16.4183 -18.7538 +1333 4 19.8428 1.38545 12.4588 7.32118 14.6694 -7.56396 +1334 4 20.1591 2.61844 11.4836 4.96023 -26.6086 29.2353 +1335 6 9.8437 37.1731 18.0697 32.5344 -3.69518 -7.02483 +1336 4 9.9915 37.607 18.9153 -11.6933 2.16478 7.61773 +1337 4 10.7629 37.1686 17.7045 -22.2666 -4.61022 -1.39483 +1338 6 22.8273 7.39987 18.8956 -5.5011 7.28813 -36.492 +1339 4 23.2632 7.84344 18.1165 -7.98371 -8.25387 20.5209 +1340 4 21.8866 7.2843 18.6392 14.3432 0.686453 4.84686 +1341 6 12.8601 6.85899 39.0577 6.92589 -13.3495 -12.6124 +1342 4 12.2887 7.60854 39.1608 -14.8411 14.7282 0.271429 +1343 4 13.3423 6.79713 39.8797 5.00888 -0.905409 12.2129 +1344 6 10.1643 2.40912 23.2548 -13.4149 21.1074 -1.06732 +1345 4 10.2774 2.03439 22.3894 8.18098 -13.9841 -15.6202 +1346 4 9.49692 3.09648 23.049 6.99386 -4.39158 13.7206 +1347 6 12.5495 20.2147 19.5723 7.26787 8.21028 -18.3895 +1348 4 11.6895 19.7983 19.735 -1.5185 0.18686 -8.43892 +1349 4 12.6119 20.404 18.6017 -2.05058 -6.51038 26.2392 +1350 6 53.8702 6.35891 18.9198 29.7306 -6.18586 8.10346 +1351 4 53.0457 6.06715 19.2818 -21.258 -2.7468 0.110915 +1352 4 54.4788 6.08079 19.6257 -1.29631 10.1734 -11.3531 +1353 6 1.76233 4.00968 13.2412 15.2049 -20.178 -6.82767 +1354 4 1.1126 4.5015 13.7221 -14.7745 7.27862 5.55391 +1355 4 1.46634 3.0803 13.3195 6.22895 8.64986 -3.00031 +1356 6 2.68809 16.4658 4.58471 15.0105 -8.44828 17.4213 +1357 4 3.47968 16.3912 5.17607 -18.0483 5.65918 -16.5792 +1358 4 2.952 17.0668 3.88721 1.61121 4.43717 -9.18758 +1359 6 22.6412 7.38905 35.0491 -42.342 -19.7774 -51.2585 +1360 4 21.8701 7.10292 34.411 47.7649 22.3984 34.2121 +1361 4 22.4927 6.7758 35.7601 0.300803 -9.30322 17.5195 +1362 6 30.6449 27.8966 19.9 11.2186 24.5725 -17.4668 +1363 4 31.067 28.6028 19.3405 -15.311 -24.4133 12.7333 +1364 4 30.0502 27.364 19.3383 6.18265 4.0422 4.40167 +1365 6 18.3584 9.54031 6.21119 11.0026 -3.68808 23.2716 +1366 4 18.3645 9.12256 5.3612 -2.33489 -5.22153 -19.3682 +1367 4 19.1216 9.13552 6.66909 -8.40358 6.03455 -2.63927 +1368 6 21.0207 30.3946 30.8361 -20.2261 -14.3153 8.76877 +1369 4 21.7305 31.0371 30.8947 0.539155 4.23503 10.2216 +1370 4 20.6128 30.1908 31.727 18.9681 11.2591 -24.4987 +1371 6 28.3223 4.36971 15.0862 0.785553 22.566 1.53388 +1372 4 27.9162 3.53142 15.2341 -13.4814 -22.4749 6.99245 +1373 4 29.0547 4.16931 14.5133 14.7433 -0.183871 -4.75122 +1374 6 12.7699 0.652736 16.5284 -10.9622 36.0111 -3.70833 +1375 4 13.1417 1.43405 17.0195 -7.22472 -23.339 -11.6266 +1376 4 12.1312 1.03058 15.8629 17.1298 -5.78525 17.4901 +1377 6 27.5613 35.204 8.24204 -17.5468 -3.17574 2.50179 +1378 4 28.0037 35.3359 7.41158 3.58667 2.22765 -10.9792 +1379 4 26.8513 34.5538 8.04841 12.0719 12.2779 8.55847 +1380 6 24.0727 5.16129 41.0114 25.3265 34.0312 4.62534 +1381 4 24.5764 6.00631 41.0278 8.83913 -22.6202 16.662 +1382 4 23.4512 5.41721 40.3589 -27.9927 -11.5371 -21.4854 +1383 6 16.8577 24.9409 28.3044 -13.362 20.9446 -8.34262 +1384 4 15.8529 24.9248 28.4711 42.0709 9.51562 -15.4474 +1385 4 17.0929 25.6637 27.6385 -20.1406 -20.6283 22.1367 +1386 6 20.8367 12.7872 17.016 48.1357 -13.7972 -0.957512 +1387 4 20.9831 13.7012 17.3244 -4.24853 -6.44611 -2.53838 +1388 4 21.7731 12.3998 16.8344 -46.2893 13.5674 8.59046 +1389 6 35.7698 23.0286 30.9167 1.31549 -8.15919 10.0357 +1390 4 34.8007 23.0783 30.9694 4.38358 -0.634017 0.107585 +1391 4 36.0504 22.6611 31.7855 -2.79806 7.45108 -14.1947 +1392 6 36.3049 21.4 25.8723 16.8231 15.2703 -10.059 +1393 4 35.3849 21.2313 25.7163 -23.5769 -6.11261 -4.10927 +1394 4 36.6855 20.6326 26.2849 5.24534 -13.4215 6.45433 +1395 6 13.4896 6.74946 5.28081 -28.3592 57.2786 25.4238 +1396 4 13.8414 6.02988 4.86679 44.4058 -71.9847 -33.7479 +1397 4 12.7199 6.9047 4.75258 -19.8414 9.95147 -1.72496 +1398 6 20.8046 20.4221 13.7595 5.24729 11.8597 -23.4966 +1399 4 21.3314 20.3763 14.5586 1.04488 -1.4591 8.76088 +1400 4 19.8874 20.2651 13.9627 -8.54986 -4.70556 7.47732 +1401 6 20.3763 29.1306 1.39291 -22.654 9.61717 24.1604 +1402 4 20.4714 29.8874 2.01179 2.99602 -8.49852 -9.62387 +1403 4 19.4639 28.7985 1.61052 22.0838 3.18086 -13.1329 +1404 6 50.878 13.1268 37.2744 -6.92527 18.9089 19.2141 +1405 4 51.431 12.5903 37.8743 -5.40112 9.96959 -2.47836 +1406 4 50.5327 13.8902 37.8162 10.8793 -23.2499 -13.6212 +1407 6 33.933 34.1706 20.4988 -24.935 23.2996 -4.02345 +1408 4 33.9537 34.3969 19.5503 3.97405 -5.2202 10.173 +1409 4 33.1424 34.6907 20.8306 20.6842 -17.0796 -4.50693 +1410 6 26.2139 28.0427 27.5441 -18.3219 -6.87449 2.92541 +1411 4 26.6233 28.4264 28.3298 2.52406 0.509022 -5.28732 +1412 4 25.2474 28.0355 27.7473 15.6982 -2.70826 -9.65401 +1413 6 7.68199 21.3044 4.2899 -23.4352 7.97399 30.3744 +1414 4 8.39223 20.9571 3.80392 40.3202 -21.1106 -20.5498 +1415 4 7.23721 21.8696 3.67656 -12.7303 12.1883 -10.427 +1416 6 21.997 15.1678 5.91921 0.156106 10.1967 -8.47357 +1417 4 22.4631 15.3078 5.09012 1.49736 10.8302 -2.43488 +1418 4 21.9323 14.2285 5.99467 -4.63281 -19.7734 10.7123 +1419 6 21.7161 24.0028 3.81129 14.7157 -6.77156 -2.79544 +1420 4 22.6514 24.278 3.99089 -16.266 -7.57571 -5.80044 +1421 4 21.7278 23.1773 3.27349 4.3704 10.7286 8.25651 +1422 6 11.5654 23.7677 12.5675 4.34126 23.9889 5.0328 +1423 4 11.8179 24.711 12.3772 -5.51197 -27.812 -0.203907 +1424 4 11.194 23.7871 13.4529 -2.51135 -1.17837 2.27349 +1425 6 32.365 18.0609 29.8133 5.42876 1.07285 10.0727 +1426 4 33.2855 17.8495 29.9872 2.18588 2.92383 8.75228 +1427 4 32.2516 17.686 28.9464 -9.45666 -7.03173 -17.6671 +1428 6 9.26057 12.3901 30.3108 6.69251 -5.93803 -6.45383 +1429 4 8.9331 13.0089 30.9751 -1.99931 -0.452864 0.983921 +1430 4 10.127 12.0766 30.6488 -15.6011 7.03664 -5.16285 +1431 6 40.1575 25.9297 9.14135 -21.3024 -7.39617 3.31146 +1432 4 40.7828 25.2448 9.36979 6.64832 -8.60816 0.262948 +1433 4 40.6901 26.6937 8.96671 10.3695 18.4246 -3.8085 +1434 6 43.1786 32.337 37.3292 -33.551 -18.2832 -9.28851 +1435 4 42.7165 32.8749 36.6701 14.8891 8.67062 4.46068 +1436 4 42.4294 31.7351 37.5575 24.0939 3.67107 5.33039 +1437 6 44.0961 6.28371 31.2632 9.51948 -8.69332 -33.5784 +1438 4 43.4914 6.92213 31.6058 -15.4833 19.2503 12.9198 +1439 4 44.559 5.89005 31.9835 8.76633 -8.79917 23.1113 +1440 6 10.2083 18.8859 19.6919 15.5822 -2.80816 -8.35433 +1441 4 10.2079 18.3466 20.4907 -1.18434 0.124911 0.125127 +1442 4 9.35433 19.315 19.665 -12.7717 3.54701 3.24565 +1443 6 7.05259 15.5816 15.0277 -11.6868 16.7681 -20.4125 +1444 4 7.21112 15.523 14.0697 -0.749561 -1.2692 3.08306 +1445 4 7.39122 14.7797 15.3874 7.84577 -24.8334 9.86289 +1446 6 24.5366 3.48359 27.8583 16.7503 5.69766 5.18976 +1447 4 23.7024 3.43271 28.3539 -4.73503 -2.50774 -10.2909 +1448 4 24.4259 3.10654 26.9763 -12.6917 -5.22111 2.5626 +1449 6 54.3931 31.8073 9.72289 -3.19054 17.1237 19.0803 +1450 4 53.9641 31.62 8.89214 -6.37727 -2.00813 -13.4715 +1451 4 54.1243 32.7301 9.92854 3.65429 -15.124 -2.64791 +1452 6 6.79493 17.0949 36.2025 -8.81624 7.47492 14.5397 +1453 4 5.9165 16.6466 36.2092 18.1356 5.91394 -12.2869 +1454 4 7.21103 17.1598 35.3293 -13.3551 -7.88765 -1.67162 +1455 6 28.633 7.46221 20.4165 -21.0133 14.9556 -29.8407 +1456 4 27.7506 7.6389 20.7846 4.83271 -6.12746 3.71795 +1457 4 28.5316 7.77661 19.4783 9.56717 -7.40103 22.9991 +1458 6 17.0376 1.7027 8.35788 5.34968 28.5352 32.0038 +1459 4 17.0661 0.753124 8.28199 -2.4228 -14.8367 -20.8379 +1460 4 16.762 2.22772 7.59129 -1.56258 -15.3605 -8.12812 +1461 6 19.1384 19.3343 35.5751 19.5023 3.30605 7.15282 +1462 4 18.4451 18.7061 35.4179 -10.2251 -8.92118 -4.92207 +1463 4 19.8852 18.808 35.914 -3.54436 4.66685 -0.605832 +1464 6 7.31639 31.3666 13.5695 -43.9944 -20.214 -21.2721 +1465 4 6.78612 30.574 13.8569 21.4883 17.7075 -0.698983 +1466 4 6.68503 31.7843 12.9295 22.0056 -0.349161 9.64417 +1467 6 16.674 5.24419 12.8556 -11.0373 -33.5815 5.02698 +1468 4 17.465 5.75961 12.9546 20.2971 3.5869 6.63236 +1469 4 16.7677 4.34295 13.2785 1.53127 21.9447 -10.2143 +1470 6 43.8803 12.7494 34.5747 -22.4085 -20.9808 -0.0671255 +1471 4 43.9515 13.6536 34.2548 -4.30422 8.76569 -3.51904 +1472 4 42.9542 12.429 34.42 18.6754 8.57765 -0.433924 +1473 6 42.6607 36.4569 28.5239 -16.8168 -12.4187 2.20896 +1474 4 42.172 37.2929 28.6321 13.9601 -3.78206 -4.91178 +1475 4 43.5913 36.5775 28.2923 4.62592 13.2896 -0.105187 +1476 6 35.3772 15.0586 6.04009 27.912 48.9275 -7.18458 +1477 4 35.887 15.8982 5.7897 -19.1126 -32.2788 12.1212 +1478 4 34.8045 14.9281 5.27735 -5.52923 -7.04807 -1.55591 +1479 6 19.4078 5.85855 6.1829 -40.2001 -18.9085 -3.31614 +1480 4 18.5441 5.99364 6.63156 8.43156 -9.10613 -8.3884 +1481 4 19.928 6.53616 6.54489 31.8426 31.4232 15.0663 +1482 6 29.261 38.1682 6.98131 -37.2303 32.1811 -6.57247 +1483 4 28.4837 38.0966 7.57517 15.5489 -1.40449 -6.41795 +1484 4 29.8842 37.5088 7.21603 19.671 -25.1607 10.5683 +1485 6 19.357 26.1782 8.47801 4.74765 -18.9961 17.9486 +1486 4 19.3733 25.7814 9.38274 -2.97831 10.6699 -17.265 +1487 4 20.1618 25.7953 8.09114 -4.76457 3.34604 0.730176 +1488 6 4.92328 16.6713 6.1398 7.47336 5.27851 2.26954 +1489 4 5.50113 17.3858 5.8203 -2.76896 -2.40075 1.51866 +1490 4 5.42288 15.8417 6.02573 -4.96937 12.5626 -0.560722 +1491 6 6.06184 16.6875 28.0703 25.9558 6.64688 1.10321 +1492 4 5.15824 16.4097 27.9597 -16.212 -5.66481 -14.185 +1493 4 6.48748 16.8231 27.1848 -21.9791 -6.00697 19.2504 +1494 6 21.7362 29.3702 22.1089 -17.2737 20.913 34.8846 +1495 4 21.4452 30.3289 22.1112 6.19611 -27.0689 0.469942 +1496 4 21.3293 28.9728 22.9428 14.5469 12.9694 -26.9427 +1497 6 24.4985 0.540505 12.8515 12.2489 -9.36427 2.95715 +1498 4 24.0437 0.939092 12.114 -3.50986 5.42614 -10.4761 +1499 4 24.1106 0.99496 13.5957 -0.561841 3.41965 12.163 +1500 6 18.4019 28.2584 40.3145 -11.401 19.5033 -15.6681 +1501 4 18.3886 27.6361 41.0165 -1.05122 -20.6036 22.2694 +1502 4 19.1831 28.024 39.826 8.23901 2.08545 -8.43276 +1503 6 10.3826 17.4565 21.9113 1.92941 -13.2413 3.45357 +1504 4 9.8824 16.6205 21.8349 3.82121 7.52813 2.02092 +1505 4 9.93899 17.9725 22.5913 -5.82795 2.16988 4.16556 +1506 6 13.5489 13.3588 39.6353 11.9209 29.8927 39.0415 +1507 4 13.8427 14.2544 39.3649 -8.64321 -16.3346 -3.85104 +1508 4 13.5548 13.4385 40.6332 -1.97454 -11.1079 -31.9482 +1509 6 19.5449 26.0093 24.7389 -52.2633 13.2593 -7.73686 +1510 4 19.57 25.3975 24.0097 10.2262 -10.7296 -10.4349 +1511 4 20.3304 26.0184 25.2393 35.6126 -10.3894 17.1361 +1512 6 8.93096 25.8929 20.0882 -7.71251 -64.4566 3.30388 +1513 4 8.30787 26.3938 20.5887 -11.4685 32.8171 11.63 +1514 4 9.62246 26.3511 19.648 20.7791 34.2926 -13.3665 +1515 6 13.4555 41.2072 30.5108 -10.8988 -15.928 5.69795 +1516 4 14.2767 41.1294 31.0436 -12.4449 -5.39064 -3.38157 +1517 4 12.7718 40.5451 30.8276 25.6688 18.9533 -5.69319 +1518 6 21.165 21.6707 11.1126 6.53241 11.8742 3.94385 +1519 4 20.8889 20.8699 10.6872 -6.5221 -17.8932 -11.6656 +1520 4 21.171 21.4318 12.0451 -0.673303 -0.892159 6.0991 +1521 6 43.5659 10.3222 15.565 -2.18625 -17.2881 -4.53442 +1522 4 43.269 9.50121 15.139 10.696 3.36153 7.59808 +1523 4 42.8911 10.937 15.2983 -10.0921 17.3133 -0.93945 +1524 6 23.5255 5.06673 12.3063 -8.27451 55.1521 -7.02327 +1525 4 23.4703 4.15364 12.096 -5.93718 -33.8878 -14.7403 +1526 4 23.077 5.57318 11.5535 15.1023 -26.9196 22.8331 +1527 6 9.29314 15.4001 4.25145 -3.86255 -4.02248 -25.5662 +1528 4 8.9509 16.1187 4.78154 1.1615 8.22379 13.6068 +1529 4 9.97933 14.9549 4.74249 8.84801 0.0887981 11.7331 +1530 6 26.7067 10.8779 17.5788 3.55047 -19.7627 -22.9275 +1531 4 26.5537 10.995 18.4988 -3.13636 8.79354 30.8805 +1532 4 26.79 11.729 17.1566 -1.16375 6.51516 1.16674 +1533 6 26.0497 23.6027 33.6801 19.5894 25.2732 20.1931 +1534 4 25.4452 23.9936 33.0304 1.52608 5.68176 -1.06817 +1535 4 26.6384 24.3139 34.1277 -30.0139 -24.8801 -23.6693 +1536 6 7.5709 10.5028 28.9083 -0.962228 -19.583 -21.6711 +1537 4 6.74329 10.4799 29.4005 3.80738 8.46019 8.36633 +1538 4 8.19878 11.0832 29.3397 0.629116 8.24646 12.7121 +1539 6 16.498 16.9072 24.6485 7.82025 23.6222 16.3151 +1540 4 16.0345 17.7596 24.5588 5.31695 -3.73313 -0.390286 +1541 4 16.1792 16.4208 23.9083 -7.11448 -16.9587 -21.9433 +1542 6 12.549 12.7866 0.448591 8.35618 6.39845 34.9671 +1543 4 12.9768 12.9146 1.38779 -15.5602 -17.6496 -50.0052 +1544 4 12.7689 11.9205 0.0349689 0.659473 7.36742 13.3893 +1545 6 6.80731 2.45617 9.05869 -7.23501 -7.03372 -0.578084 +1546 4 7.10343 3.02287 9.78944 7.77528 -6.31722 -2.26682 +1547 4 7.3272 1.63733 8.99034 2.01029 5.74015 6.94656 +1548 6 28.8877 11.8706 12.0154 41.6386 34.6329 -2.99516 +1549 4 28.2108 12.4771 11.6895 -6.34049 1.49886 1.56166 +1550 4 29.7533 12.3393 11.8008 -29.7579 -18.4108 8.17464 +1551 6 44.6745 32.5962 29.7139 -34.2161 4.66467 6.73964 +1552 4 43.7628 32.9784 29.4642 35.9402 -16.1761 10.2258 +1553 4 44.5125 31.9002 30.3967 -1.3182 18.2082 -15.8911 +1554 6 28.5995 15.1068 32.2872 13.2766 -51.3111 -20.1848 +1555 4 29.0279 15.8582 31.8991 2.31019 19.0875 -3.40369 +1556 4 29.0943 14.3419 31.8537 -21.7517 23.8731 20.1718 +1557 6 1.14062 22.1898 33.6289 -39.3586 14.574 19.5436 +1558 4 0.65227 22.798 33.0535 3.91391 -2.7929 6.08546 +1559 4 1.82717 21.8879 33.088 34.4042 -16.5957 -27.8984 +1560 6 17.4513 16.8201 9.93098 -1.82085 -23.3459 26.2514 +1561 4 17.8906 17.1746 9.18159 7.86355 15.3521 -22.135 +1562 4 18.0267 16.0779 10.2085 -7.73246 7.19916 -1.96586 +1563 6 18.7435 29.8048 14.4095 21.7061 -3.72347 40.0221 +1564 4 19.5652 29.5706 14.9087 -19.4331 3.67999 -8.42588 +1565 4 18.9661 29.6909 13.4944 1.97037 -1.23698 -19.2163 +1566 6 39.4071 6.51101 13.0179 12.0574 6.81682 -11.0022 +1567 4 39.7785 7.30288 12.5709 -10.193 -11.7897 7.6563 +1568 4 39.9532 5.78104 12.6849 -4.03584 4.98089 5.48617 +1569 6 54.0977 38.2821 14.3159 8.76467 -13.509 23.2458 +1570 4 53.5116 38.6447 15.0061 0.0542658 1.01747 -18.4972 +1571 4 53.8554 38.6311 13.4594 -12.9742 11.219 -5.93773 +1572 6 7.52036 32.013 20.9427 34.362 14.2167 21.5407 +1573 4 7.05735 31.9924 20.1252 -18.8869 -6.37038 -21.2822 +1574 4 7.04171 31.4816 21.5607 -16.1882 -11.3569 11.099 +1575 6 26.965 15.5039 13.8257 -10.8147 -22.3452 14.7237 +1576 4 27.2177 14.7358 14.3683 8.65177 6.42067 -5.59001 +1577 4 26.0429 15.6169 14.0906 -6.80859 9.66341 -6.51148 +1578 6 18.3782 16.4473 32.1249 -4.95226 -1.86998 -9.87987 +1579 4 18.1426 16.6374 31.1969 4.73263 -0.719504 8.39792 +1580 4 19.0836 17.0573 32.3614 6.73072 6.57595 -2.73442 +1581 6 52.4873 31.678 23.2415 -44.1119 -6.58328 47.4356 +1582 4 52.4708 32.2686 24.0415 7.23299 -8.75358 -21.8316 +1583 4 53.1739 31.883 22.645 31.3465 14.6123 -23.9869 +1584 6 2.16824 9.71317 28.2162 5.46837 -18.1801 7.45826 +1585 4 2.48183 10.5213 27.7929 -7.61484 8.72751 3.65687 +1586 4 1.37959 9.87032 28.768 3.44281 10.2362 -4.06622 +1587 6 32.9194 0.0905733 22.5781 10.5432 -20.5017 -7.42813 +1588 4 33.2395 41.1185 22.3208 -17.3926 6.61176 1.08087 +1589 4 33.7441 0.505918 22.8191 5.29332 16.1982 3.6992 +1590 6 20.7309 41.5697 38.6372 28.3147 -14.9122 -44.687 +1591 4 20.0328 41.0591 39.0281 -13.7779 -1.58578 11.2509 +1592 4 21.0348 40.9602 37.8857 -7.98591 29.4899 32.1121 +1593 6 43.3035 24.332 12.1458 11.7575 -1.61212 -4.71191 +1594 4 43.2118 25.2792 12.3722 8.64503 -11.1136 -9.01316 +1595 4 44.1249 24.1975 11.6011 -17.6772 13.9566 14.4164 +1596 6 22.028 36.2965 11.8178 -12.5217 11.0116 -6.64335 +1597 4 21.6755 36.9888 11.229 7.35556 -7.61462 10.605 +1598 4 22.8593 36.0261 11.4203 4.02803 -2.23458 -0.408194 +1599 6 50.7458 20.5312 30.3336 -27.3371 19.0798 0.575242 +1600 4 50.2829 20.0188 31.024 4.3389 0.549123 -5.17754 +1601 4 50.1148 21.2814 30.1453 20.3707 -20.1638 4.65154 +1602 6 20.8352 3.85006 18.1924 -4.58005 6.82859 16.651 +1603 4 21.6331 4.17131 17.7775 4.55578 1.29171 -4.07778 +1604 4 20.7516 4.34878 19.0287 -0.852135 -6.30171 -7.97465 +1605 6 4.00732 20.6422 6.98905 -51.5603 -31.2986 19.6291 +1606 4 3.1116 20.4695 6.56725 35.2765 12.481 -1.34365 +1607 4 3.83148 20.2497 7.8921 17.5771 16.9916 -21.2359 +1608 6 11.9503 15.4361 41.4392 2.8915 -19.3712 8.63656 +1609 4 11.9967 14.4718 41.7234 3.98465 29.7679 -14.4511 +1610 4 12.4631 15.5787 40.6176 -3.08486 -9.43894 7.49139 +1611 6 3.00006 18.5443 38.9307 7.29951 -23.84 25.6029 +1612 4 3.57591 17.7463 38.8471 -9.50595 12.5214 2.28144 +1613 4 2.93408 18.9335 38.0756 -3.85177 13.2219 -26.1975 +1614 6 8.60604 38.8696 11.3027 41.4164 30.2615 0.48057 +1615 4 9.41419 39.0226 10.7506 -16.8144 -5.25469 8.62565 +1616 4 8.21901 38.0768 10.9944 -17.9318 -38.1368 -15.4555 +1617 6 12.9777 33.9736 38.4849 13.2116 9.7409 3.49313 +1618 4 12.6169 33.1824 38.0476 12.8065 1.18326 0.516457 +1619 4 13.9558 34.0654 38.367 -20.6967 -9.66923 -0.235313 +1620 6 4.68265 11.9882 6.05233 -5.36104 -17.6375 -21.4001 +1621 4 3.82121 11.6194 5.80881 -7.3972 4.97776 10.103 +1622 4 5.22981 11.6659 5.30604 -0.806592 6.4598 12.5779 +1623 6 10.8388 15.9226 25.2234 -25.8257 0.885817 -3.68505 +1624 4 11.7194 16.2357 25.361 23.5714 9.8582 3.12124 +1625 4 10.3656 16.637 24.773 5.49819 -5.38784 0.449897 +1626 6 20.7519 3.25216 6.54608 14.2232 16.6176 4.63006 +1627 4 20.286 2.47445 6.25961 -10.3965 -11.4853 -2.16446 +1628 4 20.1859 4.03183 6.47283 -6.25253 -2.40724 -3.99784 +1629 6 47.6296 39.155 31.2075 -6.94169 16.2372 -29.2685 +1630 4 46.6717 39.1522 30.9686 19.778 5.05469 4.61154 +1631 4 48.0746 39.7923 30.5789 -18.3255 -25.0069 20.1215 +1632 6 8.32942 27.7692 27.6861 -22.9675 10.5768 13.2964 +1633 4 7.92083 27.0814 28.2574 8.55111 11.2092 -8.24047 +1634 4 9.05389 27.3382 27.2479 10.5137 -11.4359 -5.41666 +1635 6 33.26 40.3166 33.4176 17.9089 -0.14465 -4.13778 +1636 4 32.5337 40.9457 33.2593 10.2249 -4.59604 -5.86803 +1637 4 34.0027 40.4737 32.781 -17.2015 3.54767 8.86095 +1638 6 24.5063 34.6298 27.2698 0.491312 8.45089 -9.78892 +1639 4 24.8706 35.531 27.0561 -9.74802 -22.5685 0.190878 +1640 4 24.1 34.2837 26.4337 10.8101 11.1551 19.1745 +1641 6 13.3248 36.7606 35.7302 31.7841 1.54421 8.12469 +1642 4 14.2215 36.6075 36.119 -13.0291 10.9369 -8.07597 +1643 4 12.8242 36.0333 36.0767 -19.6956 -11.898 1.78685 +1644 6 34.0654 20.1519 33.2169 18.328 45.6356 -7.38724 +1645 4 34.7846 20.5927 32.7056 -13.2567 -20.8909 7.62801 +1646 4 33.6055 20.9496 33.5712 -4.62613 -21.3045 2.82084 +1647 6 22.8301 33.56 31.6141 4.86266 11.3389 -12.2002 +1648 4 23.5774 34.1707 31.5466 -2.83601 4.36281 -5.03091 +1649 4 23.1188 32.9172 32.2538 0.234413 -13.6868 11.6365 +1650 6 23.7437 2.42751 19.8437 5.37542 22.288 12.015 +1651 4 24.549 1.92657 19.7151 11.8542 -9.34304 -3.08207 +1652 4 23.0522 1.96699 19.3939 -17.1839 -15.7883 -12.7178 +1653 6 10.5922 1.64055 20.5239 -11.6119 -4.18685 -4.47424 +1654 4 10.0475 0.976152 20.0603 6.63037 0.339841 6.84259 +1655 4 10.5 2.45781 20.009 1.22375 1.55874 1.33627 +1656 6 6.49834 24.8637 7.80908 13.1619 -16.462 -27.2261 +1657 4 7.39752 24.8711 7.42138 -7.39511 8.18905 12.026 +1658 4 6.07255 24.1767 7.26903 -7.5733 6.7583 6.8074 +1659 6 54.7892 32.5297 25.4757 -1.36407 18.5665 -18.8778 +1660 4 54.0312 33.1434 25.3693 10.0694 -13.7478 6.1371 +1661 4 0.333918 32.6202 24.6425 -12.8409 -6.42816 22.883 +1662 6 6.2467 20.1884 28.9797 -14.5872 3.94595 -2.55046 +1663 4 5.42154 20.1642 28.4577 8.07739 1.90281 8.6477 +1664 4 6.84484 19.6236 28.4838 10.3646 -4.74821 0.341067 +1665 6 50.0565 21.6117 11.3373 -2.04109 28.5423 -29.4123 +1666 4 50.95 21.7264 10.9878 2.40449 3.31798 -5.14809 +1667 4 50.1463 20.9073 11.9368 0.900865 -33.3483 27.1981 +1668 6 43.4794 33.5181 19.6392 10.2306 -3.22473 -8.26676 +1669 4 43.7308 33.5714 20.5426 20.9097 -0.172793 18.6354 +1670 4 42.5556 33.6283 19.7345 -31.1875 3.87355 -8.92325 +1671 6 30.8203 7.18413 41.0653 -47.5647 29.7584 13.5959 +1672 4 29.9879 7.63165 40.681 33.629 -21.8567 10.9994 +1673 4 30.7637 7.50249 0.10761 7.36747 -14.0232 -31.1296 +1674 6 12.1328 25.8622 11.0863 -33.3162 -17.1307 -4.35232 +1675 4 11.2035 26.0164 10.7385 31.652 5.74526 10.6132 +1676 4 12.7063 26.6022 10.9281 7.22016 21.1466 -6.88425 +1677 6 47.8272 5.81934 17.7377 34.4122 -10.5063 -19.6374 +1678 4 48.0885 5.28838 16.9377 -7.84164 17.03 17.5567 +1679 4 48.6906 6.1712 18.0872 -20.5621 -5.0871 -4.09565 +1680 6 35.1646 12.9005 16.5891 -8.94037 2.15609 -8.82704 +1681 4 35.428 13.0005 17.5199 -6.39768 8.78744 -5.13392 +1682 4 34.5308 13.6301 16.3523 17.2323 -15.7422 12.9621 +1683 6 10.4611 10.6156 33.9687 -31.8989 -9.58391 14.7288 +1684 4 10.7981 11.3375 34.5166 5.24051 -2.75865 -7.26377 +1685 4 9.62118 10.4004 34.4306 17.5569 -1.50819 -12.473 +1686 6 9.86916 7.4616 9.67483 -1.17411 0.415312 -19.5192 +1687 4 9.17172 8.12646 9.7346 0.921409 2.8109 10.1471 +1688 4 9.97058 7.3459 8.70248 1.1017 -0.154201 19.4763 +1689 6 11.1489 9.5612 29.1408 -3.50418 -13.4139 2.93109 +1690 4 10.6848 9.26325 29.9428 4.68224 5.10434 -5.79998 +1691 4 11.3989 8.73954 28.6776 0.998479 5.88331 1.3781 +1692 6 46.4028 12.7539 37.8993 8.34964 0.221 -8.93676 +1693 4 46.6625 12.9969 36.9769 -3.46511 -1.57209 17.4302 +1694 4 46.8246 13.3669 38.5286 -1.63466 -3.53539 -5.22058 +1695 6 4.76485 19.028 16.0085 -13.5875 12.8334 -9.71245 +1696 4 4.2246 19.0797 16.8211 14.4547 -7.44532 -2.23877 +1697 4 5.5965 18.5831 16.2078 1.83868 -2.3176 10.3072 +1698 6 50.2593 39.8135 19.3633 -11.209 7.32279 -16.1387 +1699 4 50.2357 39.0929 20.0186 -9.83071 -0.813057 -10.1916 +1700 4 49.5811 39.7404 18.6324 20.3589 -6.83946 23.6454 +1701 6 3.57863 23.2976 26.309 -19.8478 3.89203 -2.42552 +1702 4 2.95325 23.1663 25.5593 11.1236 -1.69658 12.5574 +1703 4 3.09228 23.9147 26.9028 8.7219 -10.8877 -9.85517 +1704 6 43.325 18.2347 20.509 -6.81505 -1.42332 -3.46621 +1705 4 42.8171 19.0284 20.7204 1.20306 1.51529 1.23812 +1706 4 43.8577 18.0426 21.2915 2.12676 -2.58083 4.4502 +1707 6 14.5031 41.5275 19.7277 -3.40329 -5.13047 -40.8094 +1708 4 13.9246 41.7804 20.437 0.184992 5.83632 25.1113 +1709 4 15.42 41.4218 19.9774 10.3149 -1.62678 14.571 +1710 6 29.2836 29.8681 26.9083 14.7251 3.00272 -32.0725 +1711 4 29.2754 29.741 25.8744 6.18055 14.2787 56.2455 +1712 4 30.1283 30.2623 27.2985 -22.384 -15.5718 -22.4063 +1713 6 6.3217 26.153 11.5726 -10.9318 2.11689 -6.65038 +1714 4 6.21736 25.7454 12.4421 7.16784 6.77942 9.71283 +1715 4 6.96084 26.8819 11.5675 -0.124344 -5.20772 8.78036 +1716 6 27.6636 9.22988 15.2432 27.2347 15.0341 -6.49447 +1717 4 28.4103 9.83484 14.9873 -20.1055 -14.3916 8.85848 +1718 4 27.7674 8.48088 14.6445 -1.45999 -3.40178 1.02673 +1719 6 29.7804 38.0662 17.0819 -1.94795 -3.59677 -9.66723 +1720 4 29.6031 37.2203 16.6025 -2.55573 18.1678 4.54076 +1721 4 29.1155 38.7497 16.8561 3.55432 -16.3657 1.57327 +1722 6 52.2257 28.7184 4.26028 43.5541 11.735 -13.9492 +1723 4 53.1498 28.7813 3.86382 -28.9168 1.3453 15.0129 +1724 4 51.9642 27.8111 4.13511 -4.98861 -18.1961 -3.0857 +1725 6 17.1716 16.6708 6.09349 0.800403 22.8617 11.3476 +1726 4 16.9906 17.4665 6.64994 5.32834 -8.85643 -15.9231 +1727 4 16.9912 15.9587 6.69883 -0.0606397 -19.1034 5.18453 +1728 6 36.6551 7.54529 33.4256 0.520164 -21.8515 26.6937 +1729 4 35.9994 7.02185 33.9501 8.71508 10.7979 -12.9224 +1730 4 36.139 7.85703 32.6949 -12.9525 8.58568 -17.7829 +1731 6 26.1712 3.13186 9.59195 18.1066 21.2961 -28.5304 +1732 4 26.5502 3.5196 10.357 16.0028 12.4994 23.003 +1733 4 25.6506 2.45477 9.93435 -32.3265 -38.1289 14.2303 +1734 6 1.19956 17.1196 33.1708 -2.2935 18.3305 -9.07621 +1735 4 1.01553 17.8006 32.4822 1.56489 -10.8534 12.1427 +1736 4 0.844206 17.4429 34.0214 2.04572 -1.59411 -6.06332 +1737 6 29.1739 10.178 5.37516 -2.40587 -18.3881 11.7134 +1738 4 28.5386 10.354 6.08377 0.376669 4.93981 -3.98875 +1739 4 29.4881 9.26834 5.54278 -5.29161 7.67482 -7.40705 +1740 6 9.22817 21.1342 0.188585 30.2393 3.90367 9.01386 +1741 4 10.0008 20.6689 41.6954 -19.6386 2.89796 1.05729 +1742 4 8.40981 20.8027 41.7407 -2.68979 -7.66638 -7.21336 +1743 6 7.42006 26.8879 34.8536 3.14545 16.5486 30.4349 +1744 4 7.04622 27.0927 35.7464 10.1233 -6.04195 -26.4158 +1745 4 6.87255 26.19 34.5186 -13.4343 -18.5802 -10.0193 +1746 6 18.6153 10.1647 3.02259 -21.2705 37.3854 6.86975 +1747 4 17.9982 9.42011 2.89287 2.11135 15.8633 3.52195 +1748 4 18.115 11.0437 3.25865 19.508 -44.5053 -11.6159 +1749 6 13.1266 21.2208 25.207 -7.78894 4.80204 -7.88194 +1750 4 12.927 21.6586 24.3646 3.95449 -7.72121 4.87382 +1751 4 12.8054 20.3208 25.1571 -2.69895 -8.80511 -3.48609 +1752 6 4.90585 24.4116 40.531 -24.4864 -14.2944 -35.1794 +1753 4 5.64285 24.6041 41.0938 21.6142 3.21823 7.1591 +1754 4 5.22115 23.997 39.6806 -3.1008 12.4445 27.1665 +1755 6 54.7234 6.29054 9.93868 16.9838 3.76988 -11.4262 +1756 4 54.1595 6.0167 10.6465 -16.0707 -8.53288 16.3243 +1757 4 -0.00708757 7.17696 10.1972 2.88265 8.42125 0.296955 +1758 6 51.7481 16.6603 19.3703 -0.380283 5.87397 -29.4424 +1759 4 51.6376 16.2748 18.4816 -6.94363 -1.60509 11.109 +1760 4 52.3909 17.3585 19.2003 6.35466 6.30558 5.78841 +1761 6 38.6244 2.9738 13.1093 11.8256 2.30897 44.7329 +1762 4 38.5518 3.44318 13.9917 -0.399232 -9.9856 -23.4333 +1763 4 38.2423 3.54447 12.4592 -11.1085 17.5319 -17.0773 +1764 6 19.4422 35.7095 9.59568 3.40577 -0.828385 -4.73593 +1765 4 18.7414 36.105 9.07989 -9.16576 -3.00828 -7.06541 +1766 4 19.0009 35.4265 10.4088 3.97598 4.46758 -4.25365 +1767 6 46.943 37.6271 25.6985 10.3793 1.77648 -5.56802 +1768 4 47.12 37.9785 24.823 -9.34628 8.6078 -10.4475 +1769 4 47.7536 37.1497 25.8683 2.27046 -5.59472 9.98269 +1770 6 20.0359 17.269 14.7493 3.99527 -1.04076 21.685 +1771 4 19.226 17.5112 15.2169 -1.54973 1.23777 -13.9596 +1772 4 20.6203 17.0021 15.471 1.89523 -0.789097 -10.2839 +1773 6 24.7462 29.2867 3.75843 -10.1451 -8.18783 10.4774 +1774 4 24.6712 28.3277 3.51733 13.2212 23.8029 -9.5704 +1775 4 25.3186 29.8222 3.19111 0.258423 -15.3949 -10.1904 +1776 6 3.43 8.91865 6.82525 30.9316 4.78471 42.1024 +1777 4 3.12906 8.84201 7.76799 3.51474 0.65101 -30.0512 +1778 4 4.4001 9.15772 6.93718 -35.8795 -6.21414 -10.2854 +1779 6 17.4867 30.5875 19.7089 25.363 -13.1809 -11.8275 +1780 4 18.4189 30.3609 19.3993 -33.7851 8.31766 10.936 +1781 4 16.9116 29.8624 19.4038 1.038 7.7974 -2.73085 +1782 6 13.2718 16.1862 39.0546 8.76191 -18.4723 6.03369 +1783 4 13.8233 16.8904 39.4031 3.30361 7.54485 1.72389 +1784 4 12.5422 16.5765 38.5789 -11.7633 13.4881 -8.40344 +1785 6 23.832 27.9756 11.5898 -7.03122 5.38421 -2.05105 +1786 4 23.0756 27.4469 11.9259 8.81977 12.3317 -3.01362 +1787 4 23.7182 28.9056 11.8688 -5.28793 -12.9553 -0.41204 +1788 6 14.4579 24.426 21.2343 -3.66896 12.863 -1.79834 +1789 4 13.9584 25.2806 21.2855 7.33453 -15.5065 2.73981 +1790 4 14.2661 23.9117 22.0367 -3.91682 9.90798 -0.991428 +1791 6 46.6073 15.1543 22.2965 -20.8333 -3.77381 -11.8272 +1792 4 45.9584 14.6421 21.811 -6.87655 -3.95362 10.1018 +1793 4 47.2458 15.2644 21.6001 24.1162 10.8017 0.759212 +1794 6 19.1409 29.7195 11.8497 24.0494 -34.2428 10.0272 +1795 4 18.8784 30.5975 11.5793 -19.1418 4.86007 -17.3781 +1796 4 18.6106 28.9994 11.4276 0.263541 23.8948 1.0376 +1797 6 36.9127 18.8084 27.6222 -22.9356 -21.6011 26.171 +1798 4 36.4352 18.471 26.8408 6.36827 4.7914 5.64024 +1799 4 36.536 18.2194 28.3533 14.6987 24.2872 -28.1415 +1800 6 35.8684 17.5378 25.4906 20.6945 -0.513689 -30.4481 +1801 4 36.5966 17.7728 24.866 -15.8574 8.27186 11.6809 +1802 4 35.9779 16.5759 25.48 -10.902 2.42848 10.2606 +1803 6 8.03691 41.9141 31.5248 13.0394 10.4535 -6.8036 +1804 4 8.57921 41.2412 31.9888 -13.1962 14.522 -11.1095 +1805 4 8.63283 0.684743 31.1326 -8.3799 -15.4286 7.32752 +1806 6 31.7059 34.8342 17.9371 1.99631 -25.0047 -8.79133 +1807 4 32.5911 34.4609 17.7211 -13.4776 12.334 6.09844 +1808 4 31.8527 35.7258 18.2497 13.1847 15.6537 3.27409 +1809 6 22.1093 41.055 5.1451 11.5479 29.9587 -53.8497 +1810 4 22.1004 40.5969 5.93279 -2.68624 -33.8843 55.363 +1811 4 22.7885 40.6204 4.60559 -4.38419 0.844423 3.37931 +1812 6 11.6153 5.16618 29.5584 -27.6475 13.1782 12.6346 +1813 4 12.1606 4.37097 29.6057 -8.91967 -2.9702 4.15115 +1814 4 10.7377 5.1092 30.0631 35.581 -10.2726 -16.0904 +1815 6 13.0239 9.45481 21.0754 -25.8377 -26.1508 -25.9824 +1816 4 13.6778 9.97234 21.4999 31.652 16.6928 15.5055 +1817 4 13.4195 8.72209 20.5617 -0.589626 12.3395 6.44381 +1818 6 12.4227 4.1736 0.163828 29.6522 45.8695 -12.8421 +1819 4 12.6651 3.77524 1.00427 0.341759 -1.42745 2.51987 +1820 4 13.0617 4.97102 0.020112 -31.9214 -41.0145 4.8633 +1821 6 45.168 14.6284 28.1023 4.783 -10.4532 13.0266 +1822 4 45.253 14.8969 27.1759 8.39119 -6.85383 -0.732919 +1823 4 45.9575 14.0916 28.3529 -13.3622 13.2892 -14.7888 +1824 6 52.571 19.2551 0.894665 -6.12931 -19.318 2.27414 +1825 4 52.6102 19.199 41.8388 0.592413 0.00811024 1.08479 +1826 4 52.8129 20.1442 1.11528 6.55776 18.4237 2.43046 +1827 6 0.161625 18.5694 30.5785 -3.0227 0.535636 4.36465 +1828 4 0.968981 18.7291 30.0798 6.18464 -7.16445 -2.53371 +1829 4 54.7907 19.4514 30.677 -10.8229 5.89199 6.00525 +1830 6 17.6528 28.1849 1.96402 -7.28907 9.7522 11.2687 +1831 4 16.9769 28.8628 1.74785 9.23997 -9.27082 -2.31394 +1832 4 17.6006 28.1534 2.93661 3.56557 1.38454 -8.44201 +1833 6 22.5099 30.1653 5.01109 -1.02808 20.8676 -0.473944 +1834 4 23.1753 30.1014 4.30975 -2.49536 -9.56192 4.09657 +1835 4 22.058 29.3206 5.04766 -1.45363 -6.71999 -4.50103 +1836 6 11.4023 8.80853 17.6459 -26.9993 9.53928 -4.75555 +1837 4 11.8645 8.1762 18.2108 15.3222 4.18532 1.52515 +1838 4 11.9865 9.48216 17.2519 4.47877 -12.4161 10.2871 +1839 6 32.2917 3.59674 26.8117 35.3382 32.7507 -4.14644 +1840 4 31.8458 3.34967 26.0065 -10.4154 -4.5889 -14.8452 +1841 4 32.8806 4.37505 26.5671 -21.1848 -26.3524 0.379863 +1842 6 26.835 37.1568 15.6529 -0.874066 14.8773 29.2405 +1843 4 26.7488 37.4766 16.567 0.376185 8.65421 -15.6923 +1844 4 26.6891 36.2303 15.7909 -0.851881 -23.4278 -14.9094 +1845 6 22.9473 3.40289 22.286 14.7574 -3.5158 -4.23343 +1846 4 23.2792 2.98888 21.4515 -4.53852 7.92848 16.4552 +1847 4 23.7307 3.68139 22.8048 -11.9145 -5.32443 -10.4265 +1848 6 14.6269 28.2214 5.19572 6.06687 6.51489 2.87291 +1849 4 14.1454 28.1555 4.36712 -3.39073 -3.27129 -8.45242 +1850 4 14.2747 28.9991 5.64824 0.61258 -1.12864 1.62503 +1851 6 20.2538 37.2031 16.5466 -28.2562 5.81675 18.2866 +1852 4 21.1004 37.4666 16.2032 21.0823 8.59207 -3.85991 +1853 4 20.0754 37.7549 17.3418 4.82626 -5.93036 -10.2325 +1854 6 17.9544 28.5616 23.889 16.4449 -8.57642 -4.83649 +1855 4 18.808 28.1928 23.5683 -20.3084 2.86715 8.85187 +1856 4 17.2559 27.9215 23.6535 6.51898 5.694 -2.26134 +1857 6 33.646 24.2349 25.2286 -4.54069 1.10679 -14.8717 +1858 4 33.6591 23.269 25.0602 3.54988 10.512 10.2941 +1859 4 34.0237 24.3938 26.1034 0.864522 -9.38336 -2.59148 +1860 6 9.98122 17.6138 2.21344 7.43797 -27.5786 -7.49496 +1861 4 10.832 17.5317 1.73219 -10.6429 3.93943 7.97636 +1862 4 9.86311 16.7639 2.69719 0.409905 15.8492 -4.6087 +1863 6 24.3357 36.801 8.92185 2.98992 -6.60779 12.1866 +1864 4 24.0742 37.6409 8.56425 -5.30422 15.3919 -5.44039 +1865 4 24.7315 37 9.77917 -2.43549 -6.6012 -3.30269 +1866 6 14.4004 4.29557 27.7519 47.583 -3.32523 5.14754 +1867 4 15.335 4.40276 27.3948 -30.4143 -4.44284 13.8265 +1868 4 13.81 4.42145 27.0177 -13.2435 3.17509 -11.8406 +1869 6 13.214 25.4576 35.3169 -22.1271 -24.6319 4.29258 +1870 4 13.1587 25.1592 36.2444 11.1778 9.47444 -6.90086 +1871 4 12.4637 24.9943 34.8985 11.1514 12.2923 -1.08233 +1872 6 43.7301 33.1781 24.4042 -1.93578 -20.5981 16.0744 +1873 4 44.3223 32.959 25.1725 -10.0543 8.3706 -19.7015 +1874 4 44.0713 33.9344 23.9169 6.22405 5.02536 3.22562 +1875 6 6.9686 30.4099 7.14637 29.0056 7.39031 21.9321 +1876 4 6.75777 29.9621 7.98042 -5.17066 0.417247 -5.37485 +1877 4 6.23168 30.2842 6.57126 -23.4728 -6.8193 -11.7975 +1878 6 44.4308 39.4237 21.7855 -4.33275 0.914597 7.54549 +1879 4 43.8654 38.932 21.1541 10.179 9.64354 2.62582 +1880 4 45.001 40.0603 21.3196 -6.51882 -12.4268 -7.79327 +1881 6 1.18424 16.4398 24.9903 -32.4903 25.5998 2.59769 +1882 4 0.976951 16.9992 24.2076 17.4753 -17.2203 8.72915 +1883 4 0.385168 16.6115 25.5394 23.4019 -14.126 -4.16352 +1884 6 8.17355 33.8284 10.6836 -2.7688 -6.92624 14.1509 +1885 4 8.34263 33.4451 9.83813 20.7133 -1.8248 -25.0865 +1886 4 7.32622 33.4212 10.8229 -22.0824 -0.650197 20.9959 +1887 6 45.3734 15.866 40.492 8.57481 -12.1553 -4.93844 +1888 4 44.519 15.6937 40.0698 -0.240559 4.546 7.41406 +1889 4 45.2892 16.6061 41.0987 -5.95018 0.957053 0.609678 +1890 6 38.79 4.28815 15.8976 0.37918 -2.10791 -10.8791 +1891 4 39.6838 3.98516 16.099 -1.14178 2.00828 6.51653 +1892 4 38.4576 4.71748 16.7012 5.69678 -4.45181 -3.36891 +1893 6 21.0946 9.20757 23.9781 -15.5567 7.8487 -28.256 +1894 4 20.9171 8.74785 23.1381 12.0597 -4.77706 12.6228 +1895 4 20.522 9.98378 23.8483 8.03519 -2.74416 16.612 +1896 6 6.47513 36.1489 20.0112 1.62078 -0.443995 1.26518 +1897 4 5.91587 35.3892 19.7749 1.1588 6.62155 -0.72477 +1898 4 7.29927 35.7814 20.3561 -3.99682 -1.77997 -1.59627 +1899 6 17.7466 23.4563 11.2529 28.5847 -29.2717 26.027 +1900 4 17.0283 23.9723 10.9251 -27.3158 17.875 -1.49359 +1901 4 17.6201 23.2782 12.2162 -8.22502 9.28058 -23.7318 +1902 6 2.23619 39.2644 23.5388 49.8561 -28.1857 -22.6679 +1903 4 2.97831 38.9599 24.1359 -27.9038 8.524 -11.8523 +1904 4 2.61824 39.0932 22.6246 -22.7997 11.7085 33.9524 +1905 6 21.7216 10.3211 3.08421 -18.2449 14.4951 30.0936 +1906 4 21.8041 10.0076 2.215 15.0715 -18.3252 -42.7176 +1907 4 20.7597 10.3501 3.18369 2.1836 1.89441 6.77029 +1908 6 13.3346 37.6456 26.8309 31.2085 -13.7023 -2.95714 +1909 4 12.8405 36.9633 27.2803 -9.16641 -7.21061 8.74396 +1910 4 14.167 37.1703 26.5501 -23.1686 18.0804 4.61389 +1911 6 45.6739 9.85296 8.82966 10.4005 6.57186 1.33947 +1912 4 45.3411 9.70411 7.93855 -5.0879 -2.60549 -0.62074 +1913 4 45.1871 9.30295 9.44221 -8.90854 -6.98805 -1.17873 +1914 6 39.813 32.3454 29.581 6.89703 -12.1014 5.95535 +1915 4 39.6485 31.4219 29.3549 -7.08038 -1.01192 -10.7476 +1916 4 40.3223 32.2375 30.3827 0.600223 8.34958 5.32896 +1917 6 39.1399 32.1558 8.97291 22.8595 -6.45003 -40.3239 +1918 4 39.6086 32.0592 8.09926 -10.5081 2.64219 35.3633 +1919 4 38.2198 32.2158 8.71089 -7.955 1.72328 8.07951 +1920 6 29.7568 11.3071 40.3305 36.1908 -28.2332 -10.1569 +1921 4 29.0987 10.6276 40.5022 -6.8613 -0.261357 1.73371 +1922 4 30.5966 10.7518 40.2867 -25.0211 23.0598 -1.19829 +1923 6 24.8367 19.8778 29.8512 -3.76004 22.8831 22.3698 +1924 4 24.8428 19.0032 30.2276 -1.20959 -17.1847 2.11456 +1925 4 24.5914 20.4528 30.618 6.24059 -13.3215 -18.0816 +1926 6 50.0702 29.4819 2.87168 7.70946 6.50978 -10.1722 +1927 4 50.8345 29.4231 3.46787 -5.92296 0.441099 -8.02421 +1928 4 50.4135 29.3271 1.96617 -11.3825 0.248157 19.2026 +1929 6 26.3309 13.2577 37.9673 -13.8105 -3.9786 -34.6653 +1930 4 27.2227 13.0528 37.6163 -4.21147 3.58808 27.148 +1931 4 26.2568 13.475 38.8976 18.37 3.27206 13.6317 +1932 6 24.3356 13.8068 16.1475 3.59325 -0.347239 -0.208698 +1933 4 24.7367 14.1162 16.9522 4.68271 -6.41054 14.6744 +1934 4 24.1923 14.631 15.6832 -6.43367 3.48529 -13.6665 +1935 6 21.9593 25.0956 8.01078 27.9223 3.76027 7.52529 +1936 4 22.6404 25.6041 7.51239 -14.7718 -5.75747 5.32796 +1937 4 22.4795 24.6555 8.71494 -11.0917 7.59151 -10.9937 +1938 6 50.1732 25.2931 29.034 -22.8769 -27.0861 -14.4889 +1939 4 50.9231 25.1249 28.4453 9.52927 7.92169 5.9345 +1940 4 50.3853 25.9631 29.6741 16.3661 14.9722 8.20298 +1941 6 23.1854 6.82331 7.6223 5.22953 23.7057 -4.54178 +1942 4 23.9785 7.3899 7.84298 -26.8007 -12.7469 -6.01791 +1943 4 22.4118 7.42329 7.468 18.2581 -13.076 4.30509 +1944 6 6.92213 5.8571 20.8332 2.72627 6.95854 -11.5419 +1945 4 7.54915 6.58218 20.6217 -11.8273 -13.0803 1.39721 +1946 4 6.56012 5.53917 19.9848 5.57208 -2.46181 7.62025 +1947 6 25.395 39.7583 23.949 6.36773 8.3837 -46.9746 +1948 4 25.6324 38.8356 24.0083 0.522678 -6.92882 12.1803 +1949 4 25.626 39.9451 22.9935 -8.38215 2.07882 31.2615 +1950 6 10.8464 30.695 2.12273 2.92699 -11.4721 29.0623 +1951 4 9.93667 30.8598 2.41274 2.41412 3.42254 -4.79395 +1952 4 11.0072 31.0743 1.26994 -5.60296 10.8359 -22.248 +1953 6 23.0784 40.5299 40.0517 -12.8303 7.3127 -19.6888 +1954 4 23.7801 40.7079 39.3995 -2.98216 -3.06267 5.67195 +1955 4 22.2752 40.9489 39.6621 13.0026 -6.04267 8.58422 +1956 6 29.2116 28.3822 37.564 -38.7174 33.0362 -17.1388 +1957 4 28.2182 28.3913 37.3962 39.4392 -4.09178 7.25715 +1958 4 29.4217 27.5495 37.9564 8.20519 -19.4736 9.10227 +1959 6 1.867 12.1738 18.0852 -6.50713 5.08339 -35.4355 +1960 4 2.57398 11.838 18.6163 6.10024 -5.16113 22.8519 +1961 4 1.13063 12.5086 18.5994 -2.48645 -2.83143 13.3981 +1962 6 35.8305 14.0949 8.56039 26.0881 18.3061 13.156 +1963 4 35.1714 13.4739 8.88749 -16.8661 -4.96187 -13.4504 +1964 4 35.7684 14.4109 7.636 -16.9096 -16.2229 2.78164 +1965 6 9.49198 39.8165 37.5846 25.5398 -19.6342 8.10058 +1966 4 10.4488 39.5668 37.3792 -35.3087 19.1509 -1.98674 +1967 4 9.11285 40.4907 37.0027 15.1686 -3.88151 -5.41116 +1968 6 3.54864 30.3444 19.2746 19.2588 -4.84534 25.5649 +1969 4 4.39288 30.8221 19.2218 -5.35887 2.33403 -8.35831 +1970 4 3.69938 29.8 20.0823 -8.98886 6.07327 -15.723 +1971 6 36.3172 32.3761 17.5568 -52.716 -14.5505 -10.7859 +1972 4 37.1181 32.7413 17.8285 45.3049 23.5946 19.1732 +1973 4 36.5447 31.7674 16.8589 0.0557097 -8.91784 -8.34906 +1974 6 22.0674 24.5243 41.4066 13.5104 10.4808 14.5301 +1975 4 21.9193 25.2614 0.114872 1.55544 -1.48024 -5.36737 +1976 4 21.3782 24.5469 40.7428 -11.5581 2.78113 -8.36201 +1977 6 45.7659 15.6016 11.6394 9.02046 4.78635 -7.96304 +1978 4 46.6299 16.0103 11.8091 -2.50167 -1.58301 0.968075 +1979 4 45.9087 14.6499 11.5698 3.7439 -8.72722 -0.994242 +1980 6 22.3679 20.3809 16.0361 -10.6504 -17.4294 -19.3744 +1981 4 21.763 20.3139 16.7773 -4.42579 5.53693 13.3566 +1982 4 23.0073 21.0579 16.2253 11.6801 17.1208 13.2616 +1983 6 25.8325 25.7487 18.9031 6.26908 13.5994 -10.9759 +1984 4 25.2398 26.4837 18.648 3.49723 -12.6326 6.8661 +1985 4 25.3435 25.2434 19.5576 -3.6765 -3.23145 -0.768961 +1986 6 35.3178 34.202 33.2905 -17.6504 -29.1706 1.13026 +1987 4 35.3983 35.1402 33.2641 1.24044 29.706 -1.15043 +1988 4 34.4344 34.0427 33.6774 7.05439 -0.467604 -1.03347 +1989 6 39.2901 17.1075 17.3833 -11.3112 -26.2042 -1.68945 +1990 4 39.9794 17.7123 17.5836 17.425 19.0869 4.79839 +1991 4 38.575 17.6263 16.9966 -1.50153 2.1098 -0.940241 +1992 6 0.398412 14.9432 21.7856 9.03058 1.70326 -1.90296 +1993 4 54.4474 14.9193 21.5731 -3.898 -0.019948 -1.7993 +1994 4 0.528431 14.174 22.3634 -0.170355 0.861544 -0.399335 +1995 6 15.987 23.2263 17.7743 4.36624 14.6934 -7.14303 +1996 4 15.4857 22.9799 16.9684 3.82047 1.22984 7.38673 +1997 4 16.1722 24.1939 17.7179 -4.44652 -15.4901 1.96988 +1998 6 5.24865 11.1141 17.5618 6.95422 37.8037 -9.42255 +1999 4 4.73778 10.3127 17.5906 4.69561 -15.2682 10.3552 +2000 4 6.07662 11.1201 18.0866 -14.6292 -19.4463 0.240297 +2001 6 9.34435 36.7122 13.2675 14.3848 -20.4853 -8.45434 +2002 4 9.62142 35.7704 13.1913 -3.31983 12.7393 -0.467066 +2003 4 9.65952 37.1602 12.4706 -4.49166 -2.86228 3.29419 +2004 6 25.4918 33.5767 0.585194 -13.2513 47.819 -13.0434 +2005 4 25.5067 34.5261 0.924259 2.87868 -31.0124 -5.96193 +2006 4 25.9276 33.0244 1.21144 10.5779 -12.847 23.4116 +2007 6 17.3034 24.3894 31.3332 -3.83374 11.0726 -5.16798 +2008 4 17.6693 25.1812 30.9068 -1.9735 -3.85303 -0.254684 +2009 4 16.6127 24.6926 31.9382 -2.66612 -1.73239 2.61398 +2010 6 50.552 32.7161 27.7939 3.69414 -2.86079 -12.6149 +2011 4 50.6897 33.0491 28.6758 -0.144502 8.45372 13.0825 +2012 4 49.6264 32.8868 27.6344 -12.0524 -1.73095 -4.05681 +2013 6 2.253 37.2274 16.11 8.45807 0.136394 4.49883 +2014 4 3.21927 37.2459 16.107 -3.10104 -5.97474 -11.5471 +2015 4 2.06307 37.5747 16.9848 -8.61924 1.9026 3.91491 +2016 6 25.7683 33.176 8.40354 -18.9203 -11.3347 4.07551 +2017 4 24.8717 33.1921 8.8134 13.9609 -2.48357 -8.81655 +2018 4 25.7602 32.4226 7.7918 -3.67744 3.53954 1.65329 +2019 6 24.768 7.83219 25.4219 17.632 21.1734 16.2998 +2020 4 25.4945 8.36147 25.0103 -20.1597 -14.0103 5.71998 +2021 4 24.2535 7.44908 24.728 -12.2137 -5.73332 -20.4071 +2022 6 44.006 27.3325 21.546 30.1554 -7.9652 -11.3918 +2023 4 43.2457 27.8583 21.7575 -19.7371 1.57643 -2.46296 +2024 4 43.7964 26.4976 21.0884 -11.5694 12.3441 5.98804 +2025 6 20.8391 32.0716 6.72617 12.9902 -8.35788 -26.5741 +2026 4 21.6065 31.456 6.61879 -16.2643 13.1482 10.0653 +2027 4 20.6646 32.3142 7.64123 9.40483 -3.67012 8.54308 +2028 6 0.615177 26.1024 3.99379 -2.52029 5.686 8.70358 +2029 4 0.872898 25.4419 3.3518 0.34785 -8.86692 -8.8337 +2030 4 1.24928 25.9906 4.70547 -1.00806 2.16518 1.82635 +2031 6 23.6932 0.22266 22.8575 19.6208 -9.09848 8.51526 +2032 4 23.2991 1.09802 22.9795 5.26519 -2.66393 -0.960482 +2033 4 24.6108 0.216177 23.2468 -26.6208 7.90328 -9.41734 +2034 6 35.6316 26.9489 6.47476 -11.9227 4.67096 -7.07616 +2035 4 36.2784 26.7656 7.18499 -0.847143 10.2035 -9.59556 +2036 4 35.6247 27.8854 6.12936 11.6979 -23.4314 22.5499 +2037 6 50.1669 7.09081 18.6924 -7.14542 -1.6973 -3.47771 +2038 4 50.8011 7.27946 17.9805 -1.08143 -0.293524 0.841141 +2039 4 49.7425 7.94753 18.8476 4.63932 0.367722 -3.05405 +2040 6 12.4741 14.8288 12.1922 -8.10271 -9.61402 10.4649 +2041 4 11.6958 14.4794 12.6802 13.1948 7.08912 -7.97814 +2042 4 12.1183 15.3251 11.4609 -4.91784 2.70917 -6.99785 +2043 6 52.4614 22.3688 36.3388 -11.0199 -17.3524 -23.0567 +2044 4 51.6251 21.9183 36.1306 -2.17212 11.6706 13.3338 +2045 4 52.9952 21.963 35.6316 8.38603 12.1418 11.4133 +2046 6 41.778 11.4842 39.1192 -2.94788 -8.5466 -71.3066 +2047 4 42.0712 11.6935 39.9642 18.9262 14.1801 48.2999 +2048 4 42.4688 11.7778 38.472 -13.5225 -5.5757 18.7019 +2049 6 13.7869 22.5139 39.1025 -32.0544 -7.10206 -10.9841 +2050 4 12.8164 22.2898 39.2995 40.1723 6.0649 -15.4789 +2051 4 14.0276 22.2847 38.1645 -11.932 2.241 24.8997 +2052 6 28.7471 19.519 21.8427 26.201 -31.4587 -3.42241 +2053 4 29.5077 18.8642 21.7553 -27.3151 19.4313 7.21597 +2054 4 28.709 19.939 20.977 -1.33904 3.86677 -3.41873 +2055 6 8.35104 21.6464 36.3873 -9.70021 11.1463 1.78198 +2056 4 8.59231 22.5715 36.3877 5.92817 6.74417 -5.91108 +2057 4 7.6521 21.6323 37.0621 1.10663 -7.27579 -5.05072 +2058 6 39.9466 23.9759 15.2079 21.5993 -7.98015 -41.1742 +2059 4 40.8727 23.6245 15.2724 -23.8836 11.1149 -0.884493 +2060 4 39.7538 23.9548 14.2182 -0.675121 3.14563 34.0025 +2061 6 8.14826 38.6974 22.5407 10.5164 -8.10765 28.5856 +2062 4 7.68497 39.3831 22.0542 -4.5186 11.15 0.90042 +2063 4 8.43687 39.0737 23.4204 -11.1896 -2.29822 -22.518 +2064 6 10.8609 20.1732 28.9608 12.8413 -0.923384 7.34695 +2065 4 10.0131 19.7426 29.0637 -5.9523 -4.47565 4.1188 +2066 4 10.8844 20.5008 28.0696 -0.703946 5.19258 -12.1525 +2067 6 36.9008 23.822 41.8156 -12.4363 21.7846 -10.0393 +2068 4 37.5711 23.2333 0.167128 40.9996 -19.7248 12.2972 +2069 4 36.1173 23.3131 41.9445 -23.6506 -5.40851 2.0223 +2070 6 23.7894 40.6868 33.3454 12.8596 -15.6087 -7.6142 +2071 4 23.0064 40.9655 33.8068 -12.9523 11.6172 4.83708 +2072 4 23.8763 39.7481 33.6232 3.5481 12.5289 -6.50269 +2073 6 4.67002 19.3025 35.4081 28.9654 -8.37802 15.8464 +2074 4 5.50304 19.0977 35.9037 -20.926 10.8248 -6.78781 +2075 4 4.54874 18.5079 34.879 -7.50763 -2.93955 -6.02594 +2076 6 9.44906 25.7726 10.897 4.32597 -4.58851 8.60165 +2077 4 9.18995 24.8319 10.8983 -5.5655 4.98255 -0.925486 +2078 4 8.69969 26.3126 10.6078 0.159443 -6.7376 0.514864 +2079 6 27.2776 22.4912 13.6121 -0.517147 -7.99313 -8.85992 +2080 4 27.155 21.7331 14.2088 0.0551372 2.14825 -2.63665 +2081 4 27.5226 22.1158 12.7439 -1.12325 6.52643 14.1544 +2082 6 41.0473 18.7721 23.2805 -1.65607 -7.19044 -7.91226 +2083 4 40.4257 18.2083 22.8124 7.09703 -3.21037 0.549063 +2084 4 40.4899 19.4448 23.6465 -2.2525 13.4867 10.2584 +2085 6 46.4847 28.3568 20.1596 21.4343 7.62243 20.4812 +2086 4 45.6558 28.0725 20.6313 23.6124 6.3397 2.68094 +2087 4 47.3103 28.4552 20.7557 -43.4876 -6.08109 -17.1535 +2088 6 14.856 15.3945 30.0569 12.1054 -1.48105 24.8406 +2089 4 14.6669 15.4041 29.1302 -8.67008 -4.83168 -20.7775 +2090 4 14.3859 14.629 30.4429 4.17574 5.50589 -6.96103 +2091 6 23.5299 24.7674 35.2089 8.01546 19.7663 24.3744 +2092 4 22.8065 25.3632 35.4756 2.8295 -9.26237 -7.23473 +2093 4 24.1647 24.8645 35.9517 -5.58112 -4.18239 -8.07128 +2094 6 19.8979 24.2128 28.4372 -8.55524 33.371 -10.5251 +2095 4 20.118 25.106 28.0235 -7.554 -30.7898 14.4583 +2096 4 18.9386 24.2465 28.5992 8.91169 -0.342387 -2.75065 +2097 6 45.9653 7.62821 20.2375 0.645938 -6.46631 40.9505 +2098 4 46.1455 7.81465 21.2011 -4.75538 -9.14986 -26.6761 +2099 4 46.2053 8.42523 19.7798 3.02803 13.7202 -10.1214 +2100 6 38.0274 12.476 8.2804 -12.7973 12.3245 -4.6187 +2101 4 37.3544 13.1993 8.5286 18.4233 -41.2645 -20.6098 +2102 4 37.689 11.8001 7.60922 -1.16355 31.2483 23.3325 +2103 6 46.9232 18.1908 8.45127 -20.6048 6.85227 14.7641 +2104 4 46.2435 17.4987 8.55233 4.56757 4.50302 -0.225601 +2105 4 47.4224 17.9381 7.68168 11.4282 -5.99968 -17.9171 +2106 6 10.854 13.9656 9.37577 10.6617 18.3473 -18.9154 +2107 4 10.3554 14.661 8.90618 -4.87744 -10.6328 11.7585 +2108 4 11.7492 14.0754 8.99486 -7.79483 -7.36366 10.4335 +2109 6 34.413 5.42618 14.0852 -12.6861 0.159125 26.6885 +2110 4 35.1199 5.9296 13.6715 10.4361 -4.78744 -13.6438 +2111 4 34.2786 4.53955 13.7091 11.464 2.02167 -7.62295 +2112 6 0.18261 0.234369 22.9555 2.77695 -16.1069 -0.480131 +2113 4 0.268342 41.6651 22.1144 -0.0234796 4.94264 7.55149 +2114 4 54.831 1.09037 22.7433 -8.12427 18.964 -5.90735 +2115 6 40.9343 30.5497 37.8912 -0.822728 -5.40818 -2.29365 +2116 4 40.0406 30.8803 38.1728 23.6728 -16.1598 5.2797 +2117 4 41.3254 29.8415 38.4693 -14.8835 20.0143 -6.13723 +2118 6 16.6534 17.3205 12.6874 14.7099 15.3782 -9.06546 +2119 4 16.1954 16.505 12.4572 -1.18797 -4.10455 -0.493236 +2120 4 17.006 17.6533 11.8352 -5.05849 -6.69802 12.8635 +2121 6 29.6898 5.4323 24.749 -0.0153423 -4.79708 -9.00604 +2122 4 30.3311 5.93507 24.2276 2.5605 1.293 3.45927 +2123 4 29.9547 5.54756 25.6733 0.859724 2.70473 -2.20341 +2124 6 49.8976 0.279 27.2063 11.3554 -10.6099 9.68168 +2125 4 49.8114 0.578981 26.2935 2.75523 0.634109 -3.06626 +2126 4 50.8097 41.8349 27.2847 -10.6363 5.42595 -5.44518 +2127 6 31.2372 31.739 15.2138 3.99594 22.7956 -4.27207 +2128 4 31.6256 30.8953 15.4507 4.79789 -4.71254 6.82751 +2129 4 31.9624 32.4004 15.1381 -14.4355 -14.737 3.33184 +2130 6 35.7805 24.1465 16.9504 11.9916 -3.59376 -8.04525 +2131 4 35.6914 24.9231 16.3572 2.28972 -11.6943 5.94213 +2132 4 36.6882 23.763 16.8157 -19.8391 7.30154 4.46135 +2133 6 24.2601 4.62781 36.7306 -2.73038 -12.1142 -21.0154 +2134 4 24.8177 5.17448 37.2794 5.25293 5.76293 7.44764 +2135 4 24.6802 4.67277 35.8537 -9.35577 -2.69704 9.81341 +2136 6 17.5719 12.8989 3.66466 27.7221 -13.8379 -12.2911 +2137 4 17.7111 13.5231 2.92461 -8.26776 -5.83385 13.2655 +2138 4 16.7968 13.1561 4.15408 -15.8703 8.33112 4.7305 +2139 6 4.16771 14.2922 18.2601 -1.91899 -29.1082 -10.1028 +2140 4 4.22837 13.3107 18.2109 4.90834 19.7408 -0.578384 +2141 4 3.27435 14.4381 18.5824 -9.9871 6.86755 4.44487 +2142 6 19.1699 36.8381 22.3902 -4.55286 10.0742 -5.97046 +2143 4 18.832 36.3461 23.1414 -4.92402 -9.67799 11.164 +2144 4 19.5712 36.1952 21.8056 6.33502 -12.5333 -3.55186 +2145 6 15.653 11.96 13.2084 19.351 18.6963 0.185202 +2146 4 15.6609 12.833 12.7547 -2.35489 -19.4305 9.56752 +2147 4 16.5767 11.8359 13.5469 -18.24 -1.16426 -6.81767 +2148 6 24.7461 21.9204 5.38797 -27.1503 3.38708 1.08719 +2149 4 25.0422 21.7466 6.29562 -9.42613 0.489783 0.293639 +2150 4 23.7615 21.7936 5.33342 31.5349 -1.60743 10.1723 +2151 6 52.731 18.5617 35.2291 -23.3227 -9.96089 -3.35821 +2152 4 52.3432 18.0885 34.4925 12.0283 -8.22578 -16.7439 +2153 4 51.9379 18.6142 35.7503 -4.18579 12.1235 24.3517 +2154 6 3.56339 27.2782 25.2861 -13.9068 -17.971 -11.9546 +2155 4 3.93933 27.1708 26.1554 6.48024 -2.07304 15.4908 +2156 4 3.97283 28.0403 24.8958 8.97188 17.1762 -5.24442 +2157 6 34.4703 32.9949 30.674 6.71734 26.132 41.1649 +2158 4 33.5303 32.9277 30.8218 -10.267 -13.4259 -20.1884 +2159 4 34.6757 33.5653 31.4552 13.6938 -14.1125 -21.2315 +2160 6 35.2703 23.7477 9.841 1.59588 4.98779 0.126485 +2161 4 34.557 23.9691 9.22977 0.987563 3.83206 0.754652 +2162 4 35.6213 22.923 9.5082 6.82753 -10.3388 -1.5208 +2163 6 42.4139 15.7114 8.97964 24.1102 0.334397 4.42901 +2164 4 41.6569 15.4185 8.4899 -23.1764 -3.9339 -8.15459 +2165 4 42.1019 15.9745 9.85446 -9.30455 -0.897043 1.06511 +2166 6 7.76859 28.8573 32.9442 -15.9037 16.0354 -10.4898 +2167 4 7.97908 28.1549 33.5519 6.36032 -10.9608 11.0673 +2168 4 8.54203 29.0732 32.4131 7.8922 -1.0693 -1.41065 +2169 6 17.6887 41.2397 36.4833 -13.2152 -10.2381 33.1554 +2170 4 16.9194 41.8027 36.6113 -2.7651 1.17246 3.809 +2171 4 17.9462 41.408 35.602 16.1966 5.46369 -29.7656 +2172 6 28.4973 24.2486 15.5471 -12.6583 -10.112 -30.4241 +2173 4 29.1017 24.9078 15.1992 6.65529 6.29726 4.69488 +2174 4 28.2904 23.7156 14.7389 1.39534 3.17619 21.4563 +2175 6 20.9519 16.2974 1.15248 44.1264 9.982 -6.69009 +2176 4 20.9895 15.4004 1.43432 -0.0798072 -22.9414 11.198 +2177 4 20.0538 16.5254 1.09156 -44.6028 7.62895 -2.50253 +2178 6 31.1717 40.7384 5.29995 -1.14335 -24.9234 -14.6262 +2179 4 30.3101 40.4535 4.98914 0.542473 -7.39845 -0.335603 +2180 4 31.0069 41.6267 5.54556 -2.10438 36.1837 12.2935 +2181 6 29.9172 24.7601 36.4536 2.52587 12.7881 -5.39704 +2182 4 30.4095 25.4459 35.9567 -7.35112 -4.48214 8.13095 +2183 4 30.0744 23.9625 35.9621 2.47343 -16.947 -5.4104 +2184 6 8.66853 31.0461 3.90506 3.77884 -22.5587 -9.29968 +2185 4 7.73756 30.8263 3.92016 -7.28297 1.54323 -1.95967 +2186 4 8.75192 31.9258 4.24445 1.80419 26.3875 10.0131 +2187 6 5.53845 32.6958 11.4143 8.71933 -16.8124 -2.49586 +2188 4 4.77303 33.2403 11.6664 3.11219 -11.1916 -2.75881 +2189 4 5.22904 31.759 11.32 0.456358 25.4252 4.80969 +2190 6 45.6505 35.4572 20.4414 3.44959 -7.44503 -2.03407 +2191 4 45.0984 35.4295 19.6379 6.4013 -0.712815 7.57821 +2192 4 46.1919 34.6303 20.4513 -12.6908 13.7486 -3.45541 +2193 6 19.5117 2.78375 9.7759 -32.3978 -9.59039 -17.0694 +2194 4 19.2358 3.70482 9.71872 -0.134373 3.8207 4.89971 +2195 4 18.7417 2.29322 9.36028 25.7327 11.9734 13.3495 +2196 6 54.9587 9.07031 10.9149 6.82732 -5.63024 12.2566 +2197 4 54.8294 8.9199 11.8667 -4.4018 -2.06217 -5.32285 +2198 4 0.663346 9.73371 10.8556 1.49355 -0.124783 -2.42855 +2199 6 21.0387 26.5729 14.7801 20.1883 -1.49652 -44.4677 +2200 4 21.3075 26.2685 13.8316 -13.9911 15.8829 47.28 +2201 4 20.1009 26.3915 14.9175 1.72514 -4.1332 -5.78598 +2202 6 14.1556 30.5195 27.5512 33.9559 3.86758 5.7066 +2203 4 14.6157 30.1887 28.3748 -9.20473 8.28645 -28.3289 +2204 4 14.8625 30.9321 26.9648 -24.7422 -11.1229 20.6028 +2205 6 29.8153 17.3336 31.0863 -17.242 12.2647 2.89366 +2206 4 30.6608 17.508 30.6961 22.1461 -2.37775 -6.86255 +2207 4 29.3509 18.1813 30.9961 -0.156979 -6.11616 8.89085 +2208 6 50.8803 17.2897 27.8178 -36.3925 19.5692 4.68662 +2209 4 49.966 17.6961 27.8739 30.6942 -17.822 -8.40051 +2210 4 51.3989 17.8346 28.4178 4.99425 -5.86793 -0.268148 +2211 6 46.2649 37.0836 13.9834 -5.2064 -3.89214 -29.9265 +2212 4 46.1297 37.5324 14.8008 -1.4234 12.1478 29.9589 +2213 4 45.6025 37.4999 13.3985 5.55615 -7.46483 0.310394 +2214 6 38.1938 37.2652 33.1426 -7.30823 -21.5307 12.8964 +2215 4 38.5245 37.3061 34.0621 0.43181 3.22683 -10.2889 +2216 4 38.5338 38.0078 32.6437 8.99657 15.0472 -1.17828 +2217 6 41.835 13.3432 31.1173 -10.6585 13.9874 21.8211 +2218 4 41.5818 13.8647 31.919 4.55225 -14.0949 -20.2689 +2219 4 42.3932 12.6177 31.4161 6.34511 -7.13184 -1.29627 +2220 6 46.8964 12.6581 17.833 -7.85032 10.4907 -16.4819 +2221 4 46.6484 13.6178 17.7542 4.08188 -24.8978 -7.40371 +2222 4 46.6377 12.1709 16.9987 5.46876 16.7046 19.0746 +2223 6 32.0579 10.0934 10.6503 -8.64381 28.9058 -4.43215 +2224 4 31.7849 9.65569 11.4853 0.173068 15.3159 -11.0765 +2225 4 31.7767 11.0763 10.6467 12.4785 -48.8318 10.7993 +2226 6 34.0094 11.373 6.75969 12.8388 24.8548 11.4886 +2227 4 33.4875 10.5861 6.69386 -15.1181 -21.0438 1.83339 +2228 4 33.7853 11.7772 7.62543 1.85262 -6.17932 -11.7084 +2229 6 45.3294 30.8612 19.494 8.3992 -12.4908 2.66791 +2230 4 45.3133 30.6326 20.4263 -2.2594 2.91399 10.7741 +2231 4 45.8271 30.1094 19.1443 -2.81922 5.63857 -5.34771 +2232 6 20.3557 0.57205 7.14927 -0.865045 4.87397 8.36509 +2233 4 20.1887 0.590785 8.10086 -2.30268 5.48708 -2.96522 +2234 4 20.2885 41.5556 6.94299 -1.24307 -13.5357 -7.1472 +2235 6 15.9783 39.4524 4.13892 -0.0151964 -9.48015 -5.29824 +2236 4 15.6158 39.9898 3.41173 1.6648 1.85694 12.5404 +2237 4 15.64 39.7774 4.99485 -4.20756 5.15612 -10.0141 +2238 6 52.4256 16.4667 25.1127 -17.0507 13.8269 -2.02364 +2239 4 51.8848 16.9346 25.7614 0.982734 -7.60925 5.82434 +2240 4 52.3383 17.0704 24.353 8.48557 -12.5426 -0.219872 +2241 6 38.5361 13.0039 3.23845 15.1533 54.069 38.768 +2242 4 38.651 13.64 4.04305 -2.16968 -28.4467 -44.0011 +2243 4 38.0019 12.309 3.58724 -16.6469 -22.8542 0.297491 +2244 6 35.13 29.6899 31.1766 -32.8294 1.63854 50.8714 +2245 4 35.4825 30.1651 30.4465 16.0479 15.276 -26.3528 +2246 4 34.6741 30.3613 31.7643 12.1102 -21.125 -19.7306 +2247 6 9.51973 33.7498 4.86217 -21.8826 5.77433 4.68556 +2248 4 9.27059 34.3826 5.57285 8.50621 -13.5655 -12.6408 +2249 4 10.3866 33.3952 5.041 8.90701 -1.44023 3.12186 +2250 6 21.534 22.0642 20.5279 -11.3341 -5.53839 17.2976 +2251 4 20.8989 22.7675 20.339 3.51908 1.76985 -0.685914 +2252 4 21.3133 21.7346 21.437 6.74336 6.48682 -22.5749 +2253 6 37.579 11.1901 41.2936 -40.5688 -13.8213 19.6839 +2254 4 37.9154 11.8125 40.6731 20.8822 18.4609 -22.3708 +2255 4 38.2848 10.6639 41.6667 19.2795 -3.39896 1.21846 +2256 6 33.8862 1.42431 38.7362 -9.76991 -12.243 -0.11253 +2257 4 33.6023 0.553369 38.4181 2.20193 5.31751 1.25532 +2258 4 33.9041 1.3558 39.7008 -0.574955 5.51976 -3.65617 +2259 6 4.57166 26.6812 27.9899 28.8485 -45.5436 -4.48952 +2260 4 5.15229 25.8908 28.1565 -23.3183 20.9594 -13.553 +2261 4 4.90489 27.293 28.6243 -0.866291 24.6335 11.5543 +2262 6 10.2514 0.902381 11.6154 -4.58149 -17.6537 26.8062 +2263 4 10.6592 1.12475 12.4668 -4.26503 -7.612 -8.38981 +2264 4 10.5004 1.60734 11.0484 5.83944 23.9466 -26.0443 +2265 6 17.6545 19.8255 2.35686 18.7122 -0.118329 6.29025 +2266 4 17.9031 20.43 1.64019 0.754008 -4.0492 2.7955 +2267 4 18.4832 19.3436 2.60738 -15.0404 10.1651 -4.64219 +2268 6 32.418 25.6758 16.4635 3.6076 24.4214 11.9097 +2269 4 33.0171 26.0095 17.1449 -9.06157 4.09224 -4.99535 +2270 4 32.7904 24.838 16.2462 -1.14602 -28.0291 -11.1265 +2271 6 33.2468 10.6359 0.32388 9.93322 -26.76 -6.12289 +2272 4 32.8861 10.0042 41.5485 10.341 19.2926 16.9559 +2273 4 34.0854 10.2367 0.697563 -23.7256 11.8288 -10.1734 +2274 6 4.94758 4.52061 10.1416 10.7499 4.98188 17.9077 +2275 4 4.04768 4.863 10.1726 -0.273394 -4.88493 2.42241 +2276 4 5.29522 4.53942 11.0694 -10.4701 1.63881 -23.2648 +2277 6 27.0943 16.9779 9.5563 -20.4641 3.47693 -11.2288 +2278 4 27.2045 17.5151 10.3493 -1.38601 2.5137 2.70549 +2279 4 26.2214 17.2494 9.17658 21.4447 -4.2653 12.7286 +2280 6 9.99194 10.5198 19.3763 9.42123 -1.05348 44.8422 +2281 4 10.4342 9.89794 18.8118 9.85784 -12.5922 -17.5865 +2282 4 10.1605 10.162 20.3013 -9.67835 15.4527 -31.558 +2283 6 19.5738 8.53792 27.8563 25.8928 -1.13542 15.4327 +2284 4 20.113 8.77024 28.6584 -12.6361 -5.62488 -23.922 +2285 4 20.1113 7.87775 27.3567 -13.5748 14.3815 9.08869 +2286 6 47.0629 38.9588 23.1271 -13.9792 1.44752 0.432651 +2287 4 47.6691 38.8737 22.3925 4.22694 -4.47738 -4.61135 +2288 4 46.1776 38.8683 22.7344 3.33277 3.24373 3.79368 +2289 6 19.6833 25.3678 11.2608 -44.4501 -0.725843 0.650565 +2290 4 19.0139 24.6272 11.3182 24.6346 19.551 -2.60477 +2291 4 19.1544 26.1629 11.5326 10.4738 -19.1562 -5.87093 +2292 6 27.3884 13.4531 15.7313 17.4935 -10.3398 7.87305 +2293 4 26.7289 13.8255 16.2909 -22.225 11.7393 10.4827 +2294 4 28.1076 13.2654 16.3619 5.43008 -3.78237 -14.8549 +2295 6 18.6476 14.1287 1.42435 5.12245 -4.46092 -43.403 +2296 4 18.3969 15.043 1.25229 -6.07889 7.26273 6.76186 +2297 4 19.169 13.9274 0.593091 -12.995 -1.5013 29.2583 +2298 6 42.2956 22.0175 32.4812 -31.5033 5.69606 -11.9689 +2299 4 42.0953 21.6028 33.3343 -5.26012 -0.0861087 1.91793 +2300 4 41.4492 22.4721 32.2087 27.3869 -15.7461 8.96812 +2301 6 10.0338 9.4525 2.5044 21.0744 -25.1182 9.26795 +2302 4 9.23419 9.82009 2.8603 -22.4046 15.9317 4.21557 +2303 4 10.2146 8.68383 3.09556 -0.513225 11.8796 -14.6695 +2304 6 6.81454 1.43994 21.9965 -17.8896 2.42247 -7.4431 +2305 4 5.91626 1.63042 21.618 24.8197 -16.2049 7.25345 +2306 4 7.09146 0.513113 21.8391 -15.5061 11.1514 -4.64506 +2307 6 11.279 27.0428 18.9739 -2.94846 37.5248 -0.887691 +2308 4 11.8405 27.0241 19.773 -2.49358 0.901506 -7.48985 +2309 4 11.2189 28.0198 18.7087 3.35633 -32.7966 13.2637 +2310 6 41.4624 20.5117 27.2131 -8.71247 23.609 -19.3396 +2311 4 41.6397 21.203 27.8749 -2.09795 -12.5822 -0.139714 +2312 4 41.4581 19.6661 27.6488 3.25287 -9.08293 14.2442 +2313 6 15.4472 24.107 33.4286 7.47915 5.78269 -2.8589 +2314 4 14.6947 24.3175 34.0087 6.10264 -6.26217 -2.67023 +2315 4 15.704 23.1687 33.5026 -8.54671 4.87938 10.939 +2316 6 36.1332 16.3778 10.0175 -2.81296 8.13669 8.31829 +2317 4 36.0433 15.4982 9.63146 0.0153009 -3.05325 1.23302 +2318 4 36.1908 16.2895 10.9807 1.05799 -3.5475 -8.17119 +2319 6 51.7056 16.2618 2.12066 8.195 -18.8618 -27.7488 +2320 4 51.3212 16.7491 2.82948 -13.5116 6.32013 30.1636 +2321 4 51.8333 15.3227 2.36395 -2.62212 15.8907 6.5854 +2322 6 23.4154 8.54771 39.774 19.4785 -4.07885 -14.0827 +2323 4 23.6619 8.92799 38.8876 -4.40964 -10.2511 30.1282 +2324 4 24.1933 8.06554 40.1323 -10.8686 15.1901 -10.9325 +2325 6 36.7652 34.4407 21.0996 -10.7203 -4.0633 -8.35763 +2326 4 37.1575 34.5988 20.2292 -2.24352 0.118594 1.89686 +2327 4 35.7922 34.4168 20.9564 13.0606 -0.027129 3.88767 +2328 6 14.1394 8.88964 27.2822 8.4001 33.0473 -16.3093 +2329 4 13.5583 8.17177 27.4325 -25.1847 -27.8879 6.89622 +2330 4 14.9981 8.62308 27.6007 12.278 -0.771553 4.38 +2331 6 20.6523 37.4857 25.1916 -4.76336 -9.80096 2.89409 +2332 4 20.8435 36.6327 24.7231 -2.60537 24.8018 1.29013 +2333 4 20.5883 38.2205 24.557 2.95927 -14.0914 0.587832 +2334 6 28.8259 24.466 30.0361 -12.0182 1.20484 18.6414 +2335 4 28.1863 24.5363 29.306 15.5663 0.0495978 -2.57679 +2336 4 29.6571 24.0617 29.7579 -0.701354 -5.27936 -13.535 +2337 6 8.3767 11.9994 23.6977 15.286 -11.9681 20.7139 +2338 4 9.3753 12.0245 23.8359 -31.6027 -4.22616 -3.50543 +2339 4 7.96209 11.4264 24.4013 16.8905 14.3689 -13.5243 +2340 6 16.0974 26.6628 22.9497 0.767107 4.93659 2.67852 +2341 4 16.422 25.9025 22.452 -4.69466 0.466105 1.02544 +2342 4 15.3072 26.4353 23.4595 5.90508 -1.9072 -2.1838 +2343 6 22.3492 41.3933 9.48833 17.1541 -15.2597 3.14364 +2344 4 22.6076 0.330473 9.13574 5.89797 15.5422 -4.87712 +2345 4 21.4389 41.4869 9.73785 -21.2641 2.73615 1.78898 +2346 6 49.3865 19.1849 32.379 28.5034 -27.5288 -8.8444 +2347 4 49.9591 18.5119 32.8294 -20.0237 22.3317 -7.01358 +2348 4 48.8882 19.6696 33.032 -5.7885 3.32597 15.4548 +2349 6 29.6797 28.4194 31.2347 -18.17 -6.54897 12.3532 +2350 4 30.6054 28.3362 30.9452 0.112823 -13.8933 8.50124 +2351 4 29.3632 27.6339 31.7874 27.6893 19.0339 -22.4607 +2352 6 5.1089 39.1304 23.5821 16.3589 -26.7425 38.52 +2353 4 5.38369 38.72 24.4786 -14.1195 25.2427 -41.8592 +2354 4 5.12138 40.0884 23.679 1.29424 5.88982 9.05127 +2355 6 42.9406 13.5828 41.5963 2.4548 -20.3274 5.45752 +2356 4 42.752 14.3543 41.1051 4.71299 30.6973 -25.311 +2357 4 42.1302 13.4831 0.159852 -12.9765 -12.2431 17.3873 +2358 6 21.226 12.4267 7.36435 31.2446 -3.521 -2.03074 +2359 4 20.2961 12.4647 7.18572 -19.4619 -2.59914 -12.879 +2360 4 21.5838 11.6146 6.96487 -5.92297 6.31526 1.33966 +2361 6 43.1402 26.8798 37.6925 36.8226 -18.0871 25.2922 +2362 4 42.3701 26.4861 37.2457 1.92095 -10.9538 3.42147 +2363 4 43.8051 26.2366 38.1772 -44.9135 25.1765 -29.4158 +2364 6 19.5374 10.6589 41.6895 -5.57828 -38.0023 -10.1688 +2365 4 19.1336 10.6448 0.637369 -6.5477 2.89313 17.0607 +2366 4 19.8005 11.5407 41.5226 10.6711 39.664 -4.3781 +2367 6 53.6211 10.0725 3.2523 6.57913 5.47914 -9.18923 +2368 4 54.2317 10.83 3.34927 -4.54537 -9.93589 0.0420736 +2369 4 54.0384 9.44833 2.62164 -2.29754 8.8252 9.03809 +2370 6 17.5636 20.1992 28.4305 -16.5699 17.1528 15.5915 +2371 4 18.0548 19.7019 27.7957 9.40873 -10.9714 -15.8242 +2372 4 18.1497 20.2955 29.1876 1.50874 1.07066 2.83373 +2373 6 36.8673 7.33814 1.69171 -42.7001 9.70605 -8.47937 +2374 4 37.6788 7.60022 2.09727 18.2611 10.2246 9.26811 +2375 4 36.4242 8.16776 1.39628 11.5951 -12.345 5.16871 +2376 6 29.225 41.4226 1.83075 -19.1389 21.107 -1.05665 +2377 4 28.4254 0.0289368 2.09685 16.3458 -11.1471 3.47601 +2378 4 29.1672 41.4088 0.871311 7.531 -2.47214 -5.14574 +2379 6 13.5148 3.09025 8.11784 -10.8355 13.5741 -3.86075 +2380 4 12.8447 3.80664 8.08285 8.27234 -10.6709 -2.48032 +2381 4 13.8247 3.09872 9.02804 1.30446 -5.60755 1.07776 +2382 6 15.035 29.5824 18.5052 -13.3664 3.09019 -9.07378 +2383 4 14.628 28.8743 17.9722 6.78876 3.62049 6.93265 +2384 4 14.2975 30.1967 18.6986 12.8362 -2.82157 -1.1162 +2385 6 10.5118 24.7077 24.3903 18.3301 23.9761 -31.3173 +2386 4 10.707 24.7057 23.4146 -4.2845 7.89501 28.372 +2387 4 10.0612 23.8909 24.4849 -17.9274 -27.8 13.6507 +2388 6 2.3293 13.8562 25.1542 8.14415 -2.44132 2.05706 +2389 4 1.63302 13.4321 24.6436 -3.32338 -7.08116 -5.4939 +2390 4 2.0923 14.7815 25.112 -7.52471 9.11743 -0.122921 +2391 6 31.8571 32.759 29.7983 3.65167 10.3578 -8.56752 +2392 4 30.9277 32.9381 29.9784 -0.622435 -3.80813 0.732423 +2393 4 31.8884 31.8723 29.4276 -3.71181 -5.10697 -2.58235 +2394 6 37.531 40.8209 33.967 -23.153 -16.1875 5.3836 +2395 4 37.3251 40.1347 34.6985 0.870468 26.6491 -35.3147 +2396 4 36.773 40.8784 33.3102 18.3716 -9.25033 25.8989 +2397 6 24.0485 38.1313 34.3431 -11.5105 1.837 -35.773 +2398 4 24.1907 38.198 35.2802 9.24451 -7.73664 19.5979 +2399 4 24.4675 37.3552 33.934 1.62169 3.10325 14.1331 +2400 6 37.1852 22.5711 7.36841 5.54302 -17.8805 15.7599 +2401 4 37.6193 21.7136 7.5635 -9.24307 15.2983 -3.07678 +2402 4 37.2973 22.7156 6.43503 3.10694 -1.55352 -15.3513 +2403 6 4.30637 23.241 35.6005 -21.8515 -3.12039 0.833232 +2404 4 4.28153 22.3978 35.1252 -1.17938 4.50836 1.52069 +2405 4 3.36633 23.5034 35.7569 13.5984 -2.36814 -1.35472 +2406 6 15.7372 14.8984 2.68389 5.83394 8.18523 30.6602 +2407 4 16.0581 15.8209 2.80401 -5.66096 -17.7803 -6.78984 +2408 4 15.4195 14.7671 1.79524 0.865375 8.28049 -11.4308 +2409 6 48.1667 23.1873 2.04358 2.14857 -5.2771 -14.5053 +2410 4 48.6748 23.4267 2.82287 11.4848 0.866046 3.26637 +2411 4 48.7964 22.9219 1.32588 -13.3162 5.875 14.6145 +2412 6 24.1221 19.9752 21.5371 -32.3717 23.6383 6.86593 +2413 4 24.143 19.3917 22.3107 11.6246 -2.80692 -10.3828 +2414 4 24.7866 19.7762 20.8968 22.5091 -14.1667 -7.68302 +2415 6 10.5822 29.3968 5.14403 -6.21678 -11.6361 15.7318 +2416 4 9.83188 29.7897 4.67624 10.1791 9.93667 -6.35089 +2417 4 11.4324 29.7717 4.90568 -2.60747 8.99296 -10.7541 +2418 6 5.96985 27.6957 31.2251 14.0826 -21.4471 -14.909 +2419 4 6.62108 27.1001 30.7651 -15.2176 13.0885 7.83628 +2420 4 6.49554 28.1541 31.8886 3.5811 4.10899 4.91189 +2421 6 18.524 25.7945 15.3346 -6.80319 -1.26411 -41.3947 +2422 4 18.3129 25.8537 16.2191 -1.03447 -6.47723 71.4836 +2423 4 17.8509 26.3975 15.0287 -5.96066 9.61194 -22.438 +2424 6 52.0911 37.2147 11.1191 10.7944 -12.7592 -3.2574 +2425 4 52.6735 36.5031 10.7991 -6.06835 6.24709 5.19982 +2426 4 52.6754 37.9802 11.2539 -6.64808 -1.57102 -0.449092 +2427 6 46.8545 14.6154 7.32174 -10.4102 9.08531 6.17155 +2428 4 46.1761 15.2305 7.76384 29.9054 -34.6086 -7.32766 +2429 4 47.196 13.9114 7.91569 -13.0839 18.0399 0.731203 +2430 6 22.2426 0.701706 41.6733 41.1626 12.534 -29.9538 +2431 4 22.236 1.66756 41.6378 -9.79705 -6.68715 4.90956 +2432 4 23.0808 0.492341 41.1545 -29.2322 -0.545859 23.5967 +2433 6 4.06645 14.7285 9.26505 -5.79968 22.7562 -12.5209 +2434 4 3.53709 15.5501 9.07402 9.13976 -21.8289 3.48331 +2435 4 4.94549 14.9564 8.94351 2.1847 -1.50717 0.750146 +2436 6 37.293 12.6643 37.0348 -15.3153 -6.18171 16.0178 +2437 4 37.7524 12.8164 37.9019 -17.8573 -2.14895 -9.99561 +2438 4 36.3666 12.3049 37.1727 33.7628 8.85249 1.83374 +2439 6 26.6624 29.0693 40.5955 -26.637 27.4899 13.7151 +2440 4 27.0962 28.2693 40.8235 19.1059 -29.7051 -2.9078 +2441 4 26.7436 29.2635 39.6647 9.93266 -1.33043 -11.4317 +2442 6 7.23743 13.8563 3.32048 -33.1041 -30.3754 -14.41 +2443 4 7.96064 14.4301 3.56742 25.5688 -7.52041 0.820923 +2444 4 7.42976 12.8854 3.09984 6.81051 43.2082 15.4509 +2445 6 8.94797 34.8532 28.8254 23.4184 -23.2786 -12.4265 +2446 4 9.89546 35.0323 28.6727 -12.7097 -5.00209 3.03018 +2447 4 8.59604 35.6886 29.0779 -14.3686 23.8739 12.2374 +2448 6 37.2014 40.0808 40.1141 12.7521 0.43192 13.6168 +2449 4 36.2619 40.0837 39.9632 -10.4254 2.72875 -6.67898 +2450 4 37.248 39.4512 40.8496 7.71934 0.19736 -2.65382 +2451 6 30.3728 6.17428 27.2502 2.34222 12.9127 24.6773 +2452 4 30.0491 5.75377 28.1093 17.5599 21.8776 -23.7977 +2453 4 31.0277 6.90628 27.4549 -18.5498 -22.5685 3.02853 +2454 6 10.4851 22.8816 18.2947 -6.39025 -14.7202 -25.3901 +2455 4 11.3539 23.0451 18.66 8.78619 -1.44678 0.615593 +2456 4 10.601 22.3432 17.4702 -0.435219 15.7289 22.4338 +2457 6 35.9047 14.2516 40.1476 -11.9566 8.08227 -8.12446 +2458 4 35.3828 14.5983 39.4171 17.9635 11.5828 -3.36223 +2459 4 35.2535 13.6726 40.504 -8.36759 -16.975 21.7169 +2460 6 6.70775 1.0715 17.7189 7.50642 -21.2746 -7.36561 +2461 4 6.22784 1.34485 18.5084 1.44497 -10.5234 3.95628 +2462 4 6.91772 0.0894674 17.7256 -13.4419 30.1572 13.7277 +2463 6 41.3365 34.0623 33.1636 23.1157 -5.84267 13.8333 +2464 4 40.4227 34.234 32.9444 -15.3258 11.3352 -14.6542 +2465 4 41.9184 34.5849 32.5841 -12.4833 3.91505 -3.84565 +2466 6 37.2858 0.99342 41.2878 7.36827 13.3221 -16.8172 +2467 4 37.4859 0.112276 40.9658 -1.88555 -12.2628 0.361589 +2468 4 37.4834 1.0172 0.312287 5.29267 -3.40266 15.6364 +2469 6 25.2541 30.9749 6.2071 -22.7336 2.5299 17.3506 +2470 4 26.0217 31.2424 5.69829 1.89843 -3.96463 -15.2281 +2471 4 24.4182 30.8551 5.69564 23.045 5.74277 3.20871 +2472 6 14.1871 24.4929 28.313 -6.35756 40.4048 -1.58139 +2473 4 14.3311 23.6816 28.7714 -3.10946 -31.1704 -0.0360927 +2474 4 13.792 24.4319 27.4273 2.40698 -14.1025 6.50138 +2475 6 34.2078 26.2332 36.0169 -41.3887 31.6455 20.302 +2476 4 35.1375 26.2713 36.1926 18.3831 1.21525 6.50399 +2477 4 33.7458 26.9646 36.5669 26.0782 -29.6148 -21.0343 +2478 6 32.3696 8.32545 27.9988 -31.7689 14.924 14.5852 +2479 4 32.5206 9.30939 28.0669 10.5891 -30.1429 -9.37737 +2480 4 33.1235 7.86931 27.6333 20.3768 10.5357 -6.59273 +2481 6 11.7881 0.276326 26.9686 -1.26514 -24.1343 -2.09554 +2482 4 11.7898 41.2288 26.6922 -1.19404 21.3361 9.01519 +2483 4 11.5977 0.31005 27.9205 2.09711 -1.6438 -10.9729 +2484 6 1.68282 0.256654 10.3371 7.78574 -7.1909 -12.7427 +2485 4 1.59984 41.2742 10.69 -0.913761 -2.35777 -0.20094 +2486 4 1.41183 0.821253 11.0453 -5.61238 10.3042 16.839 +2487 6 6.75659 13.8554 8.24275 2.15336 8.75665 -12.4729 +2488 4 6.4538 13.9004 7.29654 11.603 6.79512 25.9161 +2489 4 7.29723 14.6482 8.44053 -3.39366 -6.31817 -8.96948 +2490 6 22.229 20.5516 6.16712 -19.4021 -6.23502 11.2792 +2491 4 21.7175 21.3783 6.29668 6.22315 -10.0472 -0.391558 +2492 4 21.7004 19.8262 6.58709 9.33903 15.1246 -7.94106 +2493 6 17.3809 20.4508 10.8712 -6.33142 3.08518 -4.04876 +2494 4 16.5461 20.08 10.4568 21.8919 23.129 5.85777 +2495 4 17.5363 21.4129 10.6625 -13.97 -26.3983 1.7074 +2496 6 17.7006 4.52466 19.5892 5.66371 -4.97651 -9.86024 +2497 4 16.9376 4.52739 20.1892 -4.06273 -5.34645 -7.80596 +2498 4 17.5412 3.84457 18.8839 -0.885651 16.9891 23.3258 +2499 6 0.475545 18.1168 40.0844 5.30586 -7.45209 -16.0452 +2500 4 0.255658 18.7395 40.7612 -0.602959 14.3131 10.4938 +2501 4 1.33302 18.3868 39.7002 -7.70736 -6.31105 3.74686 +2502 6 22.9439 24.8338 27.8349 -3.23408 23.09 -51.7359 +2503 4 22.7283 25.5292 27.1178 5.97449 -27.0764 31.3639 +2504 4 22.8278 25.2464 28.677 -4.11703 14.8593 21.0934 +2505 6 42.7959 39.1553 26.7627 -13.6288 14.9904 24.3142 +2506 4 42.9559 38.4383 26.1586 10.7263 -7.78522 -15.113 +2507 4 43.351 39.9224 26.5692 3.77188 -7.24305 -5.18193 +2508 6 26.2354 3.05796 21.7982 1.74018 25.1467 -10.7915 +2509 4 25.6923 3.78105 22.1642 10.9011 -13.8467 -3.1836 +2510 4 26.7888 3.50003 21.1142 -10.0122 -11.5362 10.4851 +2511 6 54.6007 9.88011 29.5829 2.61324 -0.835643 16.9334 +2512 4 53.983 9.1383 29.6239 1.49377 0.577448 -2.59463 +2513 4 54.746 10.0983 30.5296 -2.21833 -1.79811 -18.9561 +2514 6 24.7578 33.7363 20.5387 -17.5006 5.04967 -0.0763559 +2515 4 24.6934 34.6555 20.8512 7.60819 -4.12262 3.6003 +2516 4 23.9235 33.6132 20.0554 5.3121 -3.42637 -1.44671 +2517 6 41.6963 16.3109 0.897802 2.88421 10.066 -28.0255 +2518 4 41.3077 16.0362 1.70176 -16.3219 -5.78099 30.2108 +2519 4 42.6299 16.1901 1.06805 12.6035 -3.11322 -2.97519 +2520 6 23.404 27.9303 27.4821 -1.06023 20.2241 -21.3645 +2521 4 22.8141 28.2554 28.1835 2.551 -1.87769 -8.73241 +2522 4 23.2629 28.4828 26.6516 2.17993 -16.4871 31.3925 +2523 6 32.7813 37.2936 18.7328 38.5641 -14.7697 6.75932 +2524 4 33.752 37.1016 18.9061 -34.9795 -0.437252 0.892363 +2525 4 32.8311 38.1729 18.3762 -6.70298 14.6722 -8.07554 +2526 6 21.2305 27.6771 4.7955 -18.4608 -25.795 -24.9287 +2527 4 20.5062 27.4644 5.39651 2.92048 5.31567 1.45057 +2528 4 20.941 27.2184 3.94502 12.5509 18.4099 23.8236 +2529 6 54.9409 17.9571 1.83459 -7.07205 6.42915 6.55936 +2530 4 54.7029 17.1381 1.42965 7.06691 -21.815 -7.49321 +2531 4 54.119 18.4405 1.74821 -9.38537 8.8513 -0.363257 +2532 6 36.7335 10.6984 6.58912 -34.5362 -0.324761 -4.53473 +2533 4 35.7609 10.9799 6.6143 34.1258 -12.1011 2.72213 +2534 4 36.7696 9.77633 6.90859 -3.13742 6.31851 -1.30765 +2535 6 54.2706 4.50024 14.0257 -11.269 5.99606 -15.4247 +2536 4 53.8536 5.11876 13.3604 4.87759 -11.992 26.1673 +2537 4 53.895 4.59469 14.9192 -3.76531 8.72829 -7.53187 +2538 6 22.107 12.8255 32.0148 27.0088 -6.82073 4.3703 +2539 4 21.2061 13.1328 31.8952 -10.7145 6.62508 -9.34344 +2540 4 22.7298 13.2576 31.3917 -17.4011 -3.99159 8.00208 +2541 6 15.2931 36.6619 4.04206 -24.4039 12.3238 20.1693 +2542 4 15.3606 37.6342 3.9855 6.08423 -9.62309 -2.22716 +2543 4 16.0243 36.2999 3.55051 12.1414 -1.28609 -8.9598 +2544 6 23.9518 1.27347 5.70825 1.82336 16.8815 15.3992 +2545 4 23.158 0.731739 5.71694 -5.31944 -7.03749 -3.2154 +2546 4 23.9846 1.73289 6.57368 -1.26671 -8.46254 -14.2674 +2547 6 14.3069 12.6571 15.8074 -11.3886 -13.8779 -22.9988 +2548 4 14.4908 12.4438 14.8835 17.1875 4.58775 1.43504 +2549 4 13.3991 12.3171 15.8566 5.60683 8.95198 18.2444 +2550 6 15.0463 40.2277 6.58272 -14.4539 15.1029 5.15073 +2551 4 15.8086 40.489 7.08192 22.3652 -6.01515 7.9389 +2552 4 14.4962 41.022 6.75392 -6.77819 -16.9793 -13.6053 +2553 6 48.5629 32.6194 12.091 2.37027 -5.84764 -3.4739 +2554 4 48.1048 31.8776 11.6348 7.57669 12.4587 1.43975 +2555 4 49.3373 32.9111 11.5511 -18.0393 -12.2542 5.39731 +2556 6 11.2883 31.5349 7.21941 -5.75599 -10.1169 -16.3625 +2557 4 10.675 30.8987 6.79271 12.7122 10.5617 8.56414 +2558 4 11.681 32.0415 6.48473 -4.52974 -6.63428 7.17241 +2559 6 30.1204 27.9925 10.216 2.65146 5.67665 0.571004 +2560 4 30.7332 28.7325 10.019 -7.63861 -11.6097 -0.594568 +2561 4 29.9063 27.5181 9.39417 2.857 4.22172 -1.33476 +2562 6 27.6817 22.1076 17.3717 2.13561 -8.21554 7.46684 +2563 4 27.3138 21.4721 16.7296 5.88092 9.15558 -3.1228 +2564 4 28.0594 22.8778 16.9197 -3.27829 -5.84867 -5.86393 +2565 6 12.9588 4.5965 18.1625 2.45174 -26.8216 -12.137 +2566 4 13.4346 3.75914 18.3684 -5.38503 16.4797 0.486183 +2567 4 12.5704 4.4145 17.2814 1.35975 11.1796 8.84538 +2568 6 19.7171 6.72206 19.0824 18.7149 18.1076 8.78634 +2569 4 19.0276 6.07043 19.1643 -12.8479 -14.7766 2.48779 +2570 4 20.149 6.78349 19.9504 -8.03044 -1.70313 -8.42964 +2571 6 37.158 31.386 11.4948 13.5333 -6.17925 -0.534196 +2572 4 36.3748 31.5241 12.0574 10.6691 -10.2998 8.4252 +2573 4 37.8298 30.7884 11.9154 -26.2348 9.80485 0.777976 +2574 6 3.12167 16.2038 27.3537 -19.2499 -26.3416 -14.9115 +2575 4 2.564 15.4232 27.613 17.9651 21.4634 -3.17821 +2576 4 3.05771 16.2343 26.3741 -0.0558506 5.44355 20.7735 +2577 6 15.7152 9.97508 38.3617 37.2659 20.4939 22.6587 +2578 4 16.1689 10.8384 38.1525 -17.0523 -25.976 5.55091 +2579 4 16.2475 9.64647 39.1327 -18.0975 2.21635 -20.7757 +2580 6 13.3945 14.2914 8.22355 52.7406 24.0557 20.8129 +2581 4 13.9343 15.0997 8.53617 -32.8018 -27.7376 -11.9171 +2582 4 14.0669 13.5802 8.35008 -24.0553 1.67412 -6.96019 +2583 6 1.72299 24.3133 36.3936 32.5837 -28.3335 21.1288 +2584 4 1.96116 25.1215 36.8464 -1.44419 12.4956 -1.11134 +2585 4 1.10799 24.5417 35.7277 -24.491 15.1488 -24.3141 +2586 6 11.1925 26.5189 32.9725 1.88857 3.23229 20.5962 +2587 4 10.9062 26.8258 32.1286 -6.138 -2.28585 -27.1412 +2588 4 11.0637 27.2989 33.5293 3.02186 -7.15206 7.83107 +2589 6 29.5898 0.769141 36.29 0.770047 10.6645 18.3277 +2590 4 29.1085 0.54227 35.5145 -3.81283 -13.529 -27.0487 +2591 4 28.8904 1.11515 36.8518 6.86702 4.29265 4.12775 +2592 6 43.6054 13.1224 23.9122 -2.46968 6.93561 -17.1322 +2593 4 42.8447 13.3401 24.4619 -4.47847 1.10283 0.728731 +2594 4 43.3126 13.2067 22.9653 4.50753 -0.208477 27.3689 +2595 6 7.45217 19.7807 19.6677 5.33955 -1.6221 -12.877 +2596 4 6.80427 19.1226 19.9251 -3.45906 -4.13396 8.35684 +2597 4 7.46466 19.745 18.7046 0.226191 5.91599 3.73904 +2598 6 24.4186 4.28854 7.83154 -9.27237 -3.93777 -5.86373 +2599 4 24.1141 5.19611 7.95791 2.72117 -5.11917 -0.666563 +2600 4 25.0574 4.07609 8.5187 1.73531 2.38301 -0.0162684 +2601 6 51.4783 30.2365 31.1578 4.43663 8.1051 17.8753 +2602 4 50.5719 29.9409 31.3316 -1.01079 -0.531629 -9.26743 +2603 4 51.6665 30.2531 30.2149 -6.58635 -1.64064 -12.0931 +2604 6 0.928618 23.6677 16.8891 39.1558 -2.20072 16.2176 +2605 4 0.0728448 23.4362 16.5368 -6.93512 -13.3273 -6.91209 +2606 4 1.45563 22.867 17.1505 -20.9828 13.2836 -9.64814 +2607 6 45.0876 19.3948 15.692 7.86589 27.8079 -34.4593 +2608 4 45.9117 18.9264 15.546 6.38244 -8.87865 2.87525 +2609 4 44.6429 18.9609 16.3882 -19.7965 -22.2098 30.8606 +2610 6 17.4975 8.71947 40.5884 -15.3884 33.6574 -8.04213 +2611 4 18.1832 9.38307 40.741 -0.0730079 1.31818 -0.306908 +2612 4 17.9142 7.90906 40.8182 15.4372 -26.466 6.58932 +2613 6 30.1853 27.2566 27.195 -12.9952 17.3445 1.1523 +2614 4 31.1231 27.467 27.0889 -0.851996 0.391463 0.93648 +2615 4 29.6983 28.1205 27.2412 18.1484 -22.709 -4.59112 +2616 6 43.0643 26.2027 28.3545 -5.31946 22.0639 -20.7107 +2617 4 43.281 25.753 27.5201 1.76973 -3.45008 6.18356 +2618 4 43.0898 25.5645 29.0616 2.35339 -12.574 6.70826 +2619 6 27.9963 7.58777 3.05558 10.5798 9.34284 19.8534 +2620 4 28.0446 6.83168 2.47717 -2.58104 -14.3156 -10.0889 +2621 4 28.509 7.35692 3.86128 -6.64638 2.01122 -8.68086 +2622 6 44.6822 7.22369 10.1895 -15.4824 21.4485 13.7445 +2623 4 44.4465 7.45383 11.1264 7.27839 -9.51736 -18.1425 +2624 4 45.2115 6.42757 10.2073 4.94307 -7.89984 8.76143 +2625 6 23.5336 20.3897 32.2571 -4.86538 -1.36788 -16.1605 +2626 4 23.3032 21.2113 32.7104 1.28111 0.523216 5.34569 +2627 4 23.9774 19.8232 32.8948 2.81274 0.218846 6.19737 +2628 6 37.5478 21.0473 29.278 -18.5062 7.79735 6.57819 +2629 4 37.2371 20.358 28.6908 4.72073 -14.165 -12.1471 +2630 4 36.7158 21.4163 29.628 13.2175 4.90017 2.66375 +2631 6 49.286 29.0703 28.699 10.8186 8.22027 -9.31733 +2632 4 48.7028 29.7991 28.456 -10.3299 -0.414367 -0.610456 +2633 4 50.1517 29.4276 28.433 0.637469 -9.81751 4.99071 +2634 6 47.52 18.1671 15.2208 -2.7229 30.7912 -34.1138 +2635 4 48.0078 17.7317 15.8928 12.2019 -13.0526 25.5862 +2636 4 48.0044 19.0008 15.0204 -10.6208 -16.322 3.06818 +2637 6 23.2448 11.1727 16.5931 -14.8157 -11.6244 -0.308602 +2638 4 23.8342 11.8286 16.2582 11.4387 21.3683 -6.30591 +2639 4 23.6559 10.3501 16.3116 -3.14365 -5.23997 2.15847 +2640 6 3.13911 8.33446 23.1963 -2.69702 8.14317 3.16076 +2641 4 3.4034 7.82956 22.4196 3.11719 -1.75335 -2.44085 +2642 4 3.61355 9.18537 23.1574 -2.855 -3.87959 1.25156 +2643 6 0.502965 16.1866 6.18545 3.06312 3.24934 37.7622 +2644 4 1.47856 16.2897 6.04903 -24.0003 -4.70784 4.68468 +2645 4 0.309706 16.1237 7.18858 13.4295 2.89967 -42.1744 +2646 6 43.1771 15.7066 5.83749 -5.07319 -7.51407 -5.60477 +2647 4 43.0136 16.4204 6.43488 -7.5966 11.2789 14.4199 +2648 4 44.0623 15.8898 5.5251 15.5631 0.134699 -7.60204 +2649 6 16.7019 35.4798 34.4572 -11.2013 7.16284 28.6023 +2650 4 15.9782 34.9492 34.0738 5.35466 1.61493 8.45244 +2651 4 16.3895 35.7941 35.362 6.52255 -9.83405 -29.4813 +2652 6 38.8822 7.74245 15.6771 24.467 26.2162 11.5837 +2653 4 39.1941 7.06316 15.0707 0.325231 -3.95447 -5.25413 +2654 4 39.6937 8.2709 15.9758 -30.2905 -22.5291 -12.0432 +2655 6 42.0043 36.5204 13.6369 3.57579 19.2035 0.0265624 +2656 4 41.9371 35.5667 13.6578 -6.58441 -9.91584 1.38486 +2657 4 41.1548 36.8737 13.3269 0.670997 -7.61264 0.497391 +2658 6 54.2965 15.3698 32.1203 7.94984 -1.57724 11.6593 +2659 4 0.00278476 15.9714 32.4364 -1.97539 -6.90512 -0.0853595 +2660 4 53.6257 15.9484 31.7567 -4.83125 0.736868 -4.95397 +2661 6 22.8953 13.994 39.0277 29.317 0.766946 3.70607 +2662 4 23.2673 14.8115 39.3939 -3.87119 -6.48985 -1.20924 +2663 4 21.9724 14.1463 38.894 -27.0425 2.87882 -4.26486 +2664 6 48.0413 28.5291 4.79053 -11.6037 -2.58599 22.6989 +2665 4 48.6027 28.7991 4.07655 16.555 3.34212 -19.6439 +2666 4 47.7045 29.3636 5.15455 0.064426 -0.719185 3.47056 +2667 6 48.8324 10.6079 2.66689 -4.06073 -3.45613 -38.269 +2668 4 48.225 10.1372 3.21562 -13.339 -11.2438 14.6703 +2669 4 49.3888 11.1314 3.20945 16.7197 17.33 23.918 +2670 6 17.1017 29.3417 4.42129 -6.1746 1.2215 19.6287 +2671 4 16.2515 28.9749 4.73431 4.06151 0.983408 -5.41825 +2672 4 17.5169 29.7258 5.22535 1.37581 -6.66399 -13.2687 +2673 6 27.7925 7.31966 26.5665 39.3465 35.5797 -5.30427 +2674 4 28.7629 7.09708 26.703 -34.5848 -6.71948 -0.628584 +2675 4 27.2286 6.57009 26.6643 -1.86949 -31.2701 4.24572 +2676 6 18.0221 22.0409 22.5172 -16.5701 10.2349 -21.3339 +2677 4 18.5639 21.2383 22.5163 -1.8186 -3.43948 -8.36361 +2678 4 17.5144 22.1102 21.6408 22.068 -10.0871 32.2991 +2679 6 22.1395 25.0891 16.7042 -20.9036 23.9116 7.05274 +2680 4 21.7854 25.6501 15.9625 11.5166 -19.4533 18.3362 +2681 4 22.5191 24.3092 16.3181 5.92374 -8.20656 -11.3677 +2682 6 25.488 28.4523 7.12785 -10.8823 -15.9396 20.8595 +2683 4 25.4981 28.5494 8.12476 3.48758 8.16016 -33.1398 +2684 4 25.5521 29.3092 6.69674 -1.4246 11.8198 7.49476 +2685 6 42.5416 24.7341 23.7389 -17.4504 20.5814 2.46415 +2686 4 41.7374 25.1978 24.1118 21.637 -12.0739 -8.95046 +2687 4 42.3838 23.7928 23.8344 -7.43983 -12.597 1.84916 +2688 6 6.22002 16.6178 2.47863 15.1987 22.5956 5.3052 +2689 4 5.33799 17.0017 2.41879 -13.1624 -14.3434 -0.0608379 +2690 4 6.24934 15.6649 2.55192 -10.5885 -12.312 -0.729605 +2691 6 47.3735 33.281 1.45237 -1.26376 -9.34891 -34.4477 +2692 4 47.004 34.1558 1.53803 -0.151384 8.42018 6.19826 +2693 4 47.7374 33.0316 2.29181 5.29029 2.56444 17.845 +2694 6 1.28124 36.1882 24.8833 15.6174 10.404 -23.7919 +2695 4 0.591937 36.4933 25.4703 -7.67557 -4.15788 11.0948 +2696 4 1.63511 35.375 25.2549 -3.92235 -3.89482 10.8998 +2697 6 20.9296 29.0485 16.4244 -14.8946 8.72798 0.140185 +2698 4 21.4494 28.4837 15.8729 6.14594 -21.5718 -11.6475 +2699 4 21.5122 29.7657 16.643 5.64358 11.2813 6.66084 +2700 6 18.6504 32.5428 14.1464 30.5599 1.70581 -2.73789 +2701 4 17.8579 33.056 14.2705 -20.3424 -4.20043 8.80032 +2702 4 18.5989 31.5954 14.3835 -16.0449 10.8642 1.76069 +2703 6 15.729 41.6925 0.00385817 -5.28292 -15.868 -0.0471225 +2704 4 15.6317 41.084 41.1283 -1.722 11.921 23.9575 +2705 4 15.1873 41.3899 0.782005 8.67232 1.52126 -23.9336 +2706 6 20.5292 18.4098 7.21323 -2.91221 4.89049 5.17577 +2707 4 20.2914 18.5583 8.16487 -5.028 -0.721877 -18.2737 +2708 4 19.7413 18.3526 6.62958 8.30767 0.291632 18.8261 +2709 6 35.3342 2.82915 1.61883 3.51298 26.3767 19.1091 +2710 4 35.0331 3.19583 2.50754 16.3791 -7.36031 -35.2043 +2711 4 35.9206 3.53855 1.22039 -16.4006 -18.5858 14.5973 +2712 6 48.9922 19.6721 24.94 -34.075 0.0390245 -1.22883 +2713 4 49.8199 19.2352 24.7823 16.5976 -0.114011 -0.96393 +2714 4 49.1617 20.6125 25.0649 5.94448 -3.86752 4.03728 +2715 6 26.0294 7.18427 41.5679 18.6543 -22.0446 -14.9111 +2716 4 26.7755 6.56315 41.735 -11.6555 11.6244 -4.08136 +2717 4 25.6575 7.3193 0.515359 -11.3234 5.2253 22.1616 +2718 6 22.0232 3.61039 29.0191 -5.74486 -2.38085 -7.46091 +2719 4 21.2539 3.82496 28.4513 11.98 3.27859 6.66273 +2720 4 22.2148 4.35673 29.5966 -4.60401 3.08527 0.791206 +2721 6 27.8512 32.5337 20.6565 16.709 -10.0789 14.6393 +2722 4 26.9625 32.7469 20.4552 -34.4793 1.21347 -3.16249 +2723 4 28.3469 33.1233 20.1026 12.1012 5.18966 -5.24336 +2724 6 8.41229 24.7869 3.46082 22.3386 15.1563 9.53263 +2725 4 8.90357 24.2552 2.84068 9.55631 -8.44952 -10.853 +2726 4 7.60423 24.3318 3.61908 -22.8615 -12.1417 2.22131 +2727 6 30.5897 41.7312 15.6484 22.6974 7.2585 28.5546 +2728 4 29.9644 0.0840213 16.3484 1.9076 -3.76769 -8.41354 +2729 4 30.1014 41.5664 14.8669 -20.7398 -7.21626 -25.2002 +2730 6 48.088 5.62638 21.1953 6.60529 -8.20232 0.106871 +2731 4 47.6746 6.34733 20.7055 -8.23977 -5.05625 1.96425 +2732 4 47.4017 5.06013 21.5879 -0.150274 10.975 -6.21391 +2733 6 39.4216 23.1741 35.7526 -24.6601 -13.9913 -21.1364 +2734 4 39.9113 23.6202 36.3986 28.8985 24.9348 33.8823 +2735 4 38.8958 22.5444 36.2533 -4.57276 -5.65639 2.90172 +2736 6 51.5794 33.3637 5.78804 -15.2387 -43.0642 -16.4958 +2737 4 51.7543 34.264 5.94613 8.32006 43.2545 8.99501 +2738 4 51.5314 33.243 4.82206 1.27667 3.09716 8.04215 +2739 6 40.1245 17.6149 30.7901 8.56984 -3.86721 -1.09973 +2740 4 39.7659 18.4612 31.0527 -2.58034 0.199434 5.42908 +2741 4 40.7245 17.8709 30.0792 -0.880063 -10.8459 -3.09375 +2742 6 46.409 9.80599 18.5787 -10.6525 10.5445 16.3312 +2743 4 47.1858 10.3579 18.4839 1.73901 1.20814 1.97642 +2744 4 46.4156 9.2339 17.8265 -1.18405 -17.3223 -19.0152 +2745 6 15.8964 41.084 31.9275 -7.67529 -16.3413 6.36199 +2746 4 16.5726 40.6297 31.3851 0.744388 15.1086 2.48527 +2747 4 16.0838 0.121849 31.9545 10.6182 0.477469 -6.79561 +2748 6 48.5579 25.7373 14.9245 -32.9201 0.62376 14.4593 +2749 4 49.4842 25.8337 14.7718 19.5896 2.21134 -17.0603 +2750 4 48.049 25.8802 14.1037 15.4245 2.93063 1.46628 +2751 6 39.2312 28.9787 36.1455 -14.672 -4.00104 3.01304 +2752 4 39.9934 29.3216 36.628 6.25522 6.25199 -7.03146 +2753 4 39.4638 28.7366 35.2366 10.4577 0.0924929 -3.6403 +2754 6 37.3289 21.0516 14.9314 -10.8689 -7.09111 1.49701 +2755 4 38.071 20.892 14.3011 -28.0288 10.0477 -1.14031 +2756 4 36.4673 21.3942 14.5393 36.2132 -8.93414 7.14583 +2757 6 32.4934 22.8531 15.7417 3.10645 -11.4389 20.7178 +2758 4 31.7266 22.539 15.2235 4.17967 -1.79737 6.20971 +2759 4 32.6084 22.2825 16.5528 -7.19864 12.5613 -26.7488 +2760 6 18.5678 8.15053 37.5885 12.1963 17.253 1.38788 +2761 4 19.2402 8.85275 37.7813 -15.6951 -12.294 2.78452 +2762 4 17.9606 8.11124 38.3342 2.60008 5.05619 4.87993 +2763 6 46.9436 30.3797 11.0104 1.88703 -1.83756 -2.66296 +2764 4 46.4577 30.6986 10.2121 16.8565 -15.5671 12.8865 +2765 4 47.4104 29.5424 10.7815 -11.8828 15.01 -3.66074 +2766 6 54.6316 13.0448 30.6676 -4.47091 -6.8042 2.85617 +2767 4 54.8929 12.2323 31.1402 -1.2342 7.60269 0.15722 +2768 4 54.6603 13.771 31.309 -0.297949 0.849652 -1.52079 +2769 6 32.2951 35.1224 27.9786 -1.77947 21.9995 15.3623 +2770 4 32.2792 35.8643 28.662 -2.01418 -27.5067 -15.3374 +2771 4 32.1621 34.2527 28.3767 0.559318 -0.0892981 14.8897 +2772 6 4.45055 25.4036 31.7899 -1.02142 -16.2715 16.4968 +2773 4 4.99753 24.9958 32.4777 -6.33224 -6.47315 3.67169 +2774 4 4.91071 26.2154 31.6821 9.55032 31.2277 -12.9728 +2775 6 40.7771 38.1434 21.8579 6.80518 1.6634 -4.63259 +2776 4 40.7449 39.0581 22.1203 -10.5616 15.8809 15.9679 +2777 4 41.4448 38.2055 21.1733 6.63637 -13.627 -11.1518 +2778 6 26.6799 9.85647 27.3982 -25.6987 30.8747 18.2417 +2779 4 27.0738 9.12687 26.9584 7.64189 -30.2216 -11.3166 +2780 4 25.7862 9.62595 27.7363 13.5029 -2.01996 -6.34848 +2781 6 53.4177 39.431 11.7682 60.4327 6.90374 -14.3662 +2782 4 54.4363 39.4906 11.5459 -51.7213 -2.15349 13.0324 +2783 4 53.0514 40.2823 11.4531 3.65586 -10.6921 6.91198 +2784 6 35.3318 21.4177 2.24537 5.41769 -12.1321 -20.1082 +2785 4 34.8431 20.6225 2.51379 1.47903 7.83344 1.83382 +2786 4 35.7036 21.1864 1.3528 -11.9529 6.47568 24.5243 +2787 6 4.13637 17.136 33.9211 3.37621 -12.3766 5.67686 +2788 4 4.20441 16.396 34.5697 -7.88327 11.3141 -11.775 +2789 4 3.23668 17.1493 33.5445 4.32036 -6.23827 5.33579 +2790 6 24.1551 16.173 14.6595 0.905264 -13.203 -15.7913 +2791 4 24.2344 17.0724 14.9677 3.21898 8.1818 3.14137 +2792 4 23.7074 16.2777 13.8038 1.81958 -4.41422 2.08172 +2793 6 43.135 2.84466 26.1032 13.1229 6.35408 -5.68313 +2794 4 42.2875 3.17639 26.414 -4.49653 4.08553 -4.30298 +2795 4 43.2684 3.17059 25.1875 -5.24638 -3.17663 12.7173 +2796 6 40.6938 12.184 1.56501 -11.5288 -7.07153 -25.6549 +2797 4 41.6237 12.1687 1.8186 -0.151998 5.09311 17.9246 +2798 4 40.0653 12.4844 2.24465 11.7671 0.703669 4.7582 +2799 6 47.3771 8.09383 26.755 61.1653 27.2124 16.0462 +2800 4 46.6352 7.69428 26.3774 -33.8593 -24.2939 -29.8281 +2801 4 48.1554 8.02079 26.1437 -24.5213 -4.41693 14.2109 +2802 6 35.8722 30.7298 38.4929 46.7797 8.20249 -0.795626 +2803 4 35.8437 29.9971 39.0885 -23.8052 -20.0767 8.1402 +2804 4 36.8495 30.8926 38.5637 -31.083 11.8011 -18.5205 +2805 6 51.2951 23.2205 32.4921 -21.4102 17.5258 -2.96787 +2806 4 51.6315 24.0445 32.1105 -0.705735 5.94923 -0.836877 +2807 4 52.0737 22.714 32.6486 16.7198 -16.4886 4.04233 +2808 6 30.6141 4.4461 39.6711 -15.3731 3.79473 -35.0115 +2809 4 30.9464 3.61986 40.0176 9.77962 -4.83986 19.2734 +2810 4 30.7704 5.18568 40.2576 9.11216 5.26318 14.244 +2811 6 35.2646 29.7051 2.85778 -14.8887 -12.395 -20.7058 +2812 4 35.7986 29.7272 2.02588 -11.2321 -1.99949 14.2373 +2813 4 34.4405 29.1492 2.64359 32.9241 21.0754 6.44042 +2814 6 50.3111 26.1454 9.40098 -22.1621 10.9454 -20.0185 +2815 4 49.986 26.7793 8.71172 15.2241 -16.6208 13.1315 +2816 4 49.7063 25.388 9.31525 11.793 4.08785 3.97386 +2817 6 50.0869 36.8245 26.4088 -20.9012 -6.38176 7.71076 +2818 4 49.5586 36.0705 26.7514 3.9746 5.79943 -8.74909 +2819 4 50.1941 37.3864 27.1871 4.41306 8.36789 0.548966 +2820 6 40.3119 23.9565 38.5384 47.4279 -1.39254 -15.5521 +2821 4 40.88 24.732 38.748 -21.3925 -13.0784 -2.40019 +2822 4 39.4343 24.1145 38.8527 -20.1214 13.5622 11.7594 +2823 6 24.9444 10.7496 30.6663 31.051 18.5451 27.0394 +2824 4 25.7305 10.8456 31.2787 -28.4 -7.1047 -26.2292 +2825 4 24.8995 11.6269 30.2371 -7.15612 -14.1049 -2.61146 +2826 6 5.89131 1.01728 5.39947 -5.16247 -17.9253 -0.227043 +2827 4 5.22088 0.340863 5.59281 2.49468 7.88844 1.50452 +2828 4 6.71299 0.544267 5.57411 4.99832 4.76302 -4.28882 +2829 6 44.2927 29.3807 26.2764 43.728 -18.4205 -0.18667 +2830 4 43.5018 29.5461 25.816 -39.4067 7.83222 -12.62 +2831 4 44.7851 28.7616 25.699 -3.50466 6.32584 16.51 +2832 6 25.3064 10.1814 6.6654 -6.94402 -15.718 -9.61204 +2833 4 25.6542 11.0594 6.61048 6.10034 18.8978 1.37462 +2834 4 25.5624 9.77067 5.8255 0.943829 -2.29537 1.40094 +2835 6 13.3606 28.0664 2.58456 21.0736 -2.27515 1.79417 +2836 4 12.4645 27.8304 2.42125 -25.9451 -0.745297 2.44011 +2837 4 13.7867 27.7237 1.79619 10.8353 3.06046 3.23802 +2838 6 6.45257 40.24 18.0133 20.0379 8.33657 1.98834 +2839 4 6.89988 39.3931 17.8777 -5.14522 -3.62214 0.392952 +2840 4 5.56311 40.1207 17.6969 -15.0406 -3.82351 -6.06839 +2841 6 47.8011 13.5056 2.01844 -10.5648 -21.267 23.3214 +2842 4 48.1524 12.6081 2.17165 -2.87721 6.43796 -2.24674 +2843 4 48.4275 13.9546 1.48105 20.9852 11.6376 -18.273 +2844 6 13.5939 20.3067 2.43603 17.8956 14.689 14.157 +2845 4 13.8339 19.6256 3.09172 -4.40777 3.66463 -6.9739 +2846 4 12.9598 19.9059 1.86118 -14.8369 -10.3601 -11.305 +2847 6 15.2334 0.8368 36.6591 1.55142 7.70692 -22.3998 +2848 4 15.2542 1.38367 37.4773 0.960764 -3.32816 -20.1037 +2849 4 15.3344 1.45306 35.8608 -4.23652 -17.7771 37.8382 +2850 6 33.6147 35.2459 15.1 16.7734 -11.8793 -18.4599 +2851 4 33.8163 35.2873 16.0538 13.2499 -3.34836 -12.9991 +2852 4 34.4154 34.9808 14.5294 -23.6504 9.8312 34.8639 +2853 6 21.8005 9.23588 0.431159 13.8262 -19.7524 30.0596 +2854 4 22.4067 9.05801 41.6249 5.27322 -0.932182 -12.5411 +2855 4 21.1072 9.74412 0.0564903 -22.836 18.1195 -16.0408 +2856 6 38.1565 27.4627 3.04439 18.4183 -28.2807 7.84104 +2857 4 37.7322 27.3164 2.21113 -4.60599 -14.2952 -24.3043 +2858 4 37.7632 28.2451 3.34335 -13.6136 36.2365 19.5187 +2859 6 38.8873 27.196 11.7739 15.5044 -8.33717 -5.93911 +2860 4 38.7841 26.3327 12.232 6.37868 6.61944 -11.5261 +2861 4 39.5786 27.1133 11.0659 -17.5863 -8.28826 19.2684 +2862 6 29.8757 41.5959 28.7066 13.5858 28.49 -11.3766 +2863 4 28.9647 41.3014 28.7466 -9.40406 -2.02578 1.88502 +2864 4 29.8997 0.254331 27.9025 -2.68961 -11.7418 13.302 +2865 6 34.0266 8.72323 38.0698 33.719 9.40995 4.6971 +2866 4 34.8877 8.24089 38.094 -11.378 13.1352 -1.62724 +2867 4 33.3712 8.08689 37.8245 -20.4874 -15.945 -8.86187 +2868 6 38.8142 27.3472 30.6886 -7.48306 -22.0573 -0.58069 +2869 4 38.4096 26.5151 30.3537 9.19692 16.3236 1.53567 +2870 4 38.2655 27.5885 31.4334 -4.0026 6.56393 5.14207 +2871 6 41.6513 17.2644 36.3568 8.49285 18.5772 4.12306 +2872 4 41.236 17.1887 35.5016 -7.55839 -3.54967 -10.3568 +2873 4 41.7813 16.3888 36.7033 1.22956 -17.0266 1.65102 +2874 6 30.7157 26.9788 35.2038 -10.151 -4.28381 0.0670681 +2875 4 31.4488 27.4236 34.7965 20.0965 0.384289 -13.2747 +2876 4 30.343 27.6484 35.7639 -8.80839 6.96039 12.3672 +2877 6 47.5342 4.10778 27.2888 11.6095 8.93875 26.3727 +2878 4 46.6105 4.27591 27.501 -8.38331 -0.425724 -4.8003 +2879 4 47.5988 3.99389 26.3497 -6.2541 -0.220522 -17.1995 +2880 6 20.9412 8.38521 7.26575 -18.1268 -17.2637 2.68033 +2881 4 20.8809 8.87169 8.08328 -6.592 1.96128 21.9757 +2882 4 21.4179 8.98778 6.73029 19.5174 18.1449 -30.7672 +2883 6 36.8608 13.6781 0.872276 -22.567 18.0135 -7.8322 +2884 4 37.3857 13.5342 1.64823 18.2236 -14.2068 17.6988 +2885 4 36.9649 12.9376 0.269125 7.56106 -9.0363 2.17502 +2886 6 28.5805 20.3012 26.4498 13.4935 0.222411 -13.7489 +2887 4 28.4835 19.3803 26.2016 0.90122 -3.21423 2.30104 +2888 4 27.7964 20.5416 26.9224 -18.5183 5.12398 12.3317 +2889 6 51.6021 16.8515 33.5179 -11.2544 -15.3 0.627003 +2890 4 51.563 16.0241 34.0301 0.916298 4.09207 -0.753195 +2891 4 51.0058 16.6639 32.7753 6.31462 4.20327 -0.345536 +2892 6 16.2626 32.019 37.6812 -31.2107 -29.2496 -22.9287 +2893 4 16.4537 31.3803 38.4011 -2.23747 12.829 -12.3594 +2894 4 15.5373 31.5705 37.1079 31.9743 21.1891 23.5065 +2895 6 14.3366 25.8859 13.2055 -16.2598 35.1345 -7.65407 +2896 4 13.5591 26.1022 13.7538 4.79106 -9.45955 4.66587 +2897 4 14.3924 26.7004 12.6499 8.67511 -16.0651 4.90492 +2898 6 54.9632 28.863 3.30225 1.80665 -46.0259 4.02989 +2899 4 54.8334 28.8705 2.33571 2.30679 -1.29159 7.0988 +2900 4 0.250446 27.9134 3.53944 -11.9885 37.0888 -10.0107 +2901 6 17.2065 5.13222 2.58226 -24.5489 -19.7693 -14.9516 +2902 4 17.8239 4.45011 2.8785 5.4716 1.45995 5.40018 +2903 4 17.4096 5.93537 3.0482 10.2082 3.99522 6.08435 +2904 6 50.7076 33.0524 10.3335 3.48719 10.0002 9.95533 +2905 4 50.6136 33.804 9.75033 0.0726689 14.8217 2.89741 +2906 4 50.6632 32.3255 9.72979 -1.7797 -23.5385 -6.20373 +2907 6 28.8719 19.8379 32.3662 12.2168 9.43689 -9.94144 +2908 4 29.8293 20.0527 32.223 -26.7315 -2.75674 4.09206 +2909 4 28.3919 20.677 32.2058 6.96369 -8.55206 2.54368 +2910 6 22.4258 12.8301 23.3099 -21.9068 12.8519 23.6974 +2911 4 22.5424 12.4187 24.2055 -3.2327 9.70973 -17.8182 +2912 4 21.6904 13.4906 23.4219 18.0295 -16.5223 -3.23075 +2913 6 54.7859 15.5473 8.87871 3.42684 8.57095 -7.37477 +2914 4 0.5152 15.244 9.45304 -3.41058 -4.28924 6.32649 +2915 4 53.9742 15.1056 9.16818 6.16615 -2.4265 3.01646 +2916 6 10.455 19.2982 26.169 33.281 -8.93788 40.2277 +2917 4 11.227 18.6906 26.1605 -15.5014 12.2348 -4.03004 +2918 4 10.0694 19.2521 25.3251 -19.4777 -1.76614 -41.28 +2919 6 38.6541 20.3016 35.2246 25.1317 -2.89776 0.584273 +2920 4 39.6122 20.389 35.0245 -16.8563 1.20482 1.7302 +2921 4 38.6037 19.6498 35.9401 -3.42784 5.37932 -3.92632 +2922 6 17.4847 18.0451 15.2473 -2.11698 43.6037 15.5575 +2923 4 17.3165 17.6253 14.4157 -4.81229 -12.7227 -25.2707 +2924 4 17.3243 19.0143 15.0283 6.45297 -29.0578 8.37137 +2925 6 29.6412 0.96029 26.2538 -2.92598 -32.1867 -14.968 +2926 4 29.2295 1.80722 25.9783 -5.05853 -19.2177 -5.0061 +2927 4 29.2302 0.136786 25.7855 11.2507 47.838 14.1271 +2928 6 30.4583 12.6781 28.2933 9.80318 -11.3268 12.128 +2929 4 29.9046 13.1756 27.6811 -9.35495 -4.05719 -6.55314 +2930 4 30.1425 11.7563 28.3949 -4.92949 12.905 -7.65094 +2931 6 36.6582 22.1039 33.3564 18.5548 3.44171 -30.7077 +2932 4 37.613 21.8793 33.4826 -21.695 5.78572 4.26475 +2933 4 36.1698 21.8632 34.1249 -2.38139 -6.6943 29.4942 +2934 6 34.851 22.4634 14.295 34.3706 -12.4795 -36.6647 +2935 4 34.1306 22.5878 14.8998 -26.9044 -0.864951 1.69223 +2936 4 34.6097 22.0485 13.4154 -10.7342 10.9778 31.0087 +2937 6 15.5278 9.60588 7.43972 42.9889 -30.8008 -13.2318 +2938 4 16.5289 9.52064 7.17624 -51.4641 3.68278 11.9177 +2939 4 15.1523 8.68078 7.51431 10.3517 24.0811 1.24627 +2940 6 21.8097 28.0449 19.8036 -9.3837 2.2861 -3.69714 +2941 4 21.8234 28.4749 20.6579 1.49564 5.45585 8.79124 +2942 4 20.892 27.7474 19.715 3.3935 -2.50466 0.747966 +2943 6 34.5377 24.4067 2.43307 17.6783 -35.0943 7.08511 +2944 4 34.5604 23.3833 2.29911 9.6022 45.0517 12.0591 +2945 4 35.2671 24.6922 3.07368 -22.5652 -15.0324 -19.8681 +2946 6 12.5974 20.9324 33.5156 -46.2472 -18.3539 -4.34371 +2947 4 11.7028 20.621 33.8238 24.9199 8.0821 6.3307 +2948 4 12.4411 20.8933 32.5604 17.1824 5.4367 5.76912 +2949 6 45.7726 31.1546 8.70236 -14.9606 25.5026 -0.599968 +2950 4 45.9029 32.1319 8.75243 4.68257 -18.3747 -3.63409 +2951 4 44.8252 31.0158 8.86685 6.58294 -2.27884 -1.49072 +2952 6 15.4856 22.546 30.183 -27.3843 -7.95278 -8.87715 +2953 4 16.2041 23.1276 30.4314 15.0704 -4.03687 4.09321 +2954 4 15.7065 21.6006 30.174 10.2057 11.8959 3.83923 +2955 6 39.7496 17.1848 38.4183 10.7213 7.86871 6.49434 +2956 4 39.4778 16.5926 37.6964 5.17631 5.73732 3.80123 +2957 4 40.5328 17.6892 38.1152 -12.3514 -12.5856 -1.70264 +2958 6 14.0114 24.6894 0.67727 2.36324 3.45559 -2.63023 +2959 4 14.2236 24.5974 1.61702 0.728832 5.12592 -0.706901 +2960 4 14.3876 25.5307 0.374588 3.08684 -2.75846 6.71077 +2961 6 31.517 19.5744 3.57234 -39.7066 16.7987 -9.47084 +2962 4 30.9812 19.3042 4.35775 22.6375 1.42354 -10.5596 +2963 4 32.4299 19.3292 3.64982 19.3858 -12.3464 7.87151 +2964 6 36.0836 25.0594 19.4567 -36.7914 6.39304 28.0525 +2965 4 37.0156 25.1955 19.4145 23.7106 3.97855 -3.98164 +2966 4 35.8434 24.7134 18.6052 0.797557 -6.28507 -17.3783 +2967 6 51.6689 17.6827 14.8094 17.1445 12.5774 26.8045 +2968 4 51.9037 18.5572 15.2299 -9.72171 -22.1194 -12.5657 +2969 4 51.1779 17.9239 14.0295 -8.26923 9.08158 -15.405 +2970 6 37.7112 27.5006 38.1887 12.9616 35.4771 9.449 +2971 4 37.6633 26.7956 37.5532 1.11487 -12.4995 -15.1422 +2972 4 38.1924 28.2458 37.7567 -11.1334 -22.4905 3.32353 +2973 6 34.7974 13.8528 30.7792 38.2139 14.8122 -13.8353 +2974 4 35.0479 14.6237 31.2931 10.1718 6.91547 -1.09557 +2975 4 34.0108 13.6012 31.1887 -47.9834 -23.6229 17.9792 +2976 6 19.6227 37.378 39.9679 -4.73731 -6.94245 -18.3615 +2977 4 20.5687 37.4692 40.1123 7.88808 5.09103 7.87528 +2978 4 19.5641 36.8976 39.1176 -6.21843 3.50671 7.67834 +2979 6 40.9479 34.0678 21.4433 -0.249567 -14.1225 -18.8789 +2980 4 41.1016 33.9428 22.3797 -2.14769 -1.67588 5.36328 +2981 4 40.6839 33.1793 21.1286 -1.36491 12.9737 -0.808456 +2982 6 32.9563 27.2052 26.5619 16.765 25.3633 38.6423 +2983 4 33.6584 27.782 27.0193 -28.2502 -21.1678 -18.3317 +2984 4 33.3196 26.985 25.7164 10.2198 -2.00428 -21.725 +2985 6 24.4119 18.6722 15.6191 2.60565 2.56356 0.790403 +2986 4 23.5591 19.1036 15.7005 -5.06369 4.62453 -0.705819 +2987 4 24.5532 18.2558 16.4735 3.02917 -4.75652 8.16225 +2988 6 29.9677 1.63803 9.07283 -8.6377 39.5876 -9.34009 +2989 4 30.0634 0.720354 9.20948 2.18912 -36.9171 5.61628 +2990 4 29.1461 1.70687 8.54641 9.48634 -0.985828 6.78106 +2991 6 31.4838 20.0989 7.86304 35.53 0.0326438 -30.7549 +2992 4 32.0429 19.6076 7.17649 -26.3889 9.76992 30.1887 +2993 4 30.8408 19.4752 8.19414 -7.49558 -12.7978 -1.24617 +2994 6 35.0504 3.77818 33.2765 0.0823497 -0.922868 12.9261 +2995 4 34.3448 4.25588 32.7981 8.7563 -3.59111 2.91721 +2996 4 34.8655 3.9194 34.2319 -2.64551 -3.11561 -17.2257 +2997 6 43.9652 7.96842 12.9746 -1.99776 -12.8019 0.966431 +2998 4 43.3695 7.30717 13.3748 13.3395 3.08022 -2.86187 +2999 4 43.3917 8.71398 12.8108 -3.39849 12.2944 -1.42541 +3000 6 44.1076 32.6848 16.9531 4.83347 14.0385 -4.8226 +3001 4 44.7886 33.3699 16.7553 -9.08835 -13.3706 7.91806 +3002 4 44.1269 32.547 17.9059 1.63547 3.97279 4.50154 +3003 6 40.604 27.1617 19.037 5.49217 0.683783 -24.0967 +3004 4 39.907 26.5243 18.7614 10.7357 10.4426 0.818988 +3005 4 41.0572 27.5561 18.2306 -16.7517 -14.1941 23.9583 +3006 6 46.0503 23.2068 29.0603 33.2935 27.7725 23.492 +3007 4 46.7239 23.8517 29.4252 -26.0483 -15.0892 -12.6312 +3008 4 46.5249 22.3737 28.9794 -1.25341 -9.22801 -2.13192 +3009 6 42.6264 30.606 18.8462 -34.271 -0.881878 -8.8004 +3010 4 43.5242 30.7893 19.1074 18.3218 -5.88078 -5.57768 +3011 4 42.5428 29.9264 18.1492 10.4183 2.57162 5.03187 +3012 6 36.1231 10.8975 23.2614 14.248 33.6052 6.96597 +3013 4 35.2264 11.248 23.1278 1.11349 -2.62395 -2.03304 +3014 4 36.6438 11.7125 23.5215 -18.5882 -27.5405 -10.5609 +3015 6 13.7387 31.5187 15.7175 -8.63655 -3.85126 -4.64142 +3016 4 14.6788 31.7096 15.8046 0.813603 4.25462 -2.48371 +3017 4 13.3439 32.0503 15.0041 7.14664 -1.81478 4.34843 +3018 6 33.1663 41.4263 27.7844 10.1514 -8.73892 50.1834 +3019 4 33.0558 0.0915148 27.0508 0.335607 20.6114 -25.4934 +3020 4 33.386 0.0476391 28.6 -4.59167 -12.6797 -24.4066 +3021 6 32.8924 22.9248 31.4777 14.8331 -14.2772 -3.0724 +3022 4 32.331 22.9976 30.6823 -4.11553 14.0534 8.76104 +3023 4 32.7731 23.648 32.1168 -12.639 5.72297 -14.9522 +3024 6 27.6514 16.8629 6.392 5.9792 -3.02818 28.7598 +3025 4 27.8554 17.3015 5.57876 -0.492343 9.99532 -20.1105 +3026 4 26.7867 16.4634 6.29535 -11.4685 -3.6273 -5.68351 +3027 6 47.2692 11.6326 26.0701 -7.51592 -12.561 -4.95541 +3028 4 47.0451 11.5188 27.0189 12.1951 16.3083 -15.426 +3029 4 47.7234 12.4489 25.7723 -5.45211 -2.19527 19.0308 +3030 6 27.5533 7.05227 7.64253 19.1893 -9.34804 28.5196 +3031 4 26.7486 7.45205 7.94122 -22.9318 8.15137 -1.85106 +3032 4 28.0959 7.04706 8.46187 -1.51515 -0.839126 -23.0353 +3033 6 39.7861 9.0687 11.9758 -15.1444 6.22431 -7.98147 +3034 4 39.495 9.25597 11.0599 4.77492 -2.72739 13.3066 +3035 4 38.9879 9.23938 12.5098 3.46881 -0.389139 -2.20355 +3036 6 18.1894 33.4728 36.1008 -27.5283 -9.1571 7.06889 +3037 4 17.6722 33.9726 35.425 4.94426 -9.47891 13.9641 +3038 4 17.5468 32.9442 36.6812 19.6546 19.0371 -24.2711 +3039 6 37.1945 26.5569 0.720807 -12.4444 8.19753 -2.53971 +3040 4 37.3568 25.6462 0.476597 4.7119 -6.04631 0.679389 +3041 4 36.2336 26.6328 0.585525 8.76389 3.8419 -0.879611 +3042 6 44.2004 19.6233 36.8917 26.7932 -13.3754 0.0595121 +3043 4 45.0387 19.0956 36.766 -19.227 18.7818 5.02367 +3044 4 44.4376 20.5683 36.9644 1.27086 -9.01627 -1.91077 +3045 6 27.7799 6.35317 35.6882 16.2858 -3.70231 1.18314 +3046 4 27.1634 6.96571 35.2926 -9.46908 3.45363 -4.90602 +3047 4 27.3042 5.53742 35.858 -2.00694 0.00942349 2.38052 +3048 6 34.7653 16.4924 20.8795 20.4023 -19.0949 10.3746 +3049 4 35.5516 15.8729 20.9898 -30.5098 25.2475 -4.70775 +3050 4 34.1298 16.2162 21.5757 7.90375 5.70636 -13.0995 +3051 6 39.0303 20.9673 40.4307 -20.4786 -67.2325 12.8224 +3052 4 38.8254 20.089 40.9106 11.5443 40.6977 -30.184 +3053 4 39.2642 21.5386 41.1412 8.11615 27.562 18.514 +3054 6 10.8068 27.9205 1.65866 27.4379 7.91142 -24.506 +3055 4 10.0967 27.7204 2.22826 -30.9372 -12.069 25.0324 +3056 4 10.8782 28.8813 1.73209 2.10338 1.16742 -2.23752 +3057 6 47.025 23.1272 13.2603 -26.8307 -11.5375 0.419605 +3058 4 47.6563 23.6094 12.7175 1.22463 1.60122 -3.88323 +3059 4 46.2701 22.846 12.6737 25.4538 5.98786 18.4886 +3060 6 34.5769 28.3999 10.6617 -26.3731 9.09486 -11.6064 +3061 4 34.5145 27.7223 11.3448 13.7244 -2.44185 1.37306 +3062 4 35.5023 28.5375 10.4336 6.33869 -4.76798 1.2135 +3063 6 3.33738 17.579 14.2816 -4.12164 13.1786 -2.02309 +3064 4 3.51487 16.7052 14.5979 -0.480238 -24.8864 6.17379 +3065 4 3.96197 18.0965 14.8055 -3.35437 6.17503 -1.46632 +3066 6 27.7248 11.5976 7.52038 4.0705 34.1711 4.34085 +3067 4 27.7194 12.5939 7.6487 2.26317 -33.1326 -4.66749 +3068 4 27.2616 11.2314 8.28138 -1.22149 -2.70865 2.4378 +3069 6 41.4317 28.339 9.02961 12.1835 18.6619 -21.5911 +3070 4 40.932 28.9387 9.57928 -8.65956 3.59764 13.3257 +3071 4 41.6711 28.9179 8.26221 -0.754142 -18.9314 12.3863 +3072 6 42.0732 4.78493 8.18399 0.592074 10.501 -23.0953 +3073 4 42.2656 5.73441 7.90258 -4.03181 -32.5079 3.94615 +3074 4 41.9391 4.19656 7.39311 5.50228 24.8072 19.85 +3075 6 28.4553 8.6408 40.3288 -1.1592 2.81238 -0.593175 +3076 4 27.8014 8.47839 41.05 3.29603 2.13238 -25.5829 +3077 4 28.0374 8.68456 39.4248 -2.58083 -3.24862 30.0681 +3078 6 0.723272 18.248 15.2854 4.61761 3.31073 11.0333 +3079 4 1.58056 18.1517 14.8782 17.0637 -0.561901 -5.4503 +3080 4 0.169553 17.7112 14.727 -13.9143 -7.94922 -7.42873 +3081 6 7.11829 16.2161 40.455 0.573222 -5.60735 -16.9123 +3082 4 7.21814 15.2583 40.7035 1.10072 25.2259 14.7352 +3083 4 7.17549 16.8833 41.1741 1.82325 -21.1089 2.38217 +3084 6 41.0856 8.6232 20.9154 1.44565 10.3804 -0.748136 +3085 4 40.3857 8.53297 20.2693 -12.0873 -13.8416 -3.91841 +3086 4 41.3541 9.53003 20.731 8.87844 6.62655 8.68036 +3087 6 31.7065 7.41805 37.5384 1.8504 0.880847 10.656 +3088 4 31.4927 7.12037 36.644 -5.569 -4.06437 0.235955 +3089 4 30.9766 7.14703 38.1182 6.88034 1.43502 -8.9471 +3090 6 40.7175 11.6353 25.4105 -5.83472 20.1078 -6.29096 +3091 4 40.8441 12.5768 25.6218 -9.59803 -8.51017 -7.38463 +3092 4 41.5254 11.2592 25.7328 13.3582 -17.7026 5.353 +3093 6 29.8893 30.1615 6.66958 6.45784 -4.04896 -4.41327 +3094 4 30.5285 30.6751 6.15191 0.92206 -5.81994 -1.29615 +3095 4 30.2313 29.249 6.64761 -0.535397 8.70224 -1.24193 +3096 6 40.83 24.591 5.67679 17.1105 23.9162 -4.99229 +3097 4 41.4401 25.3556 5.89599 -18.0089 -21.1831 -4.73113 +3098 4 40.1352 24.5742 6.32932 -4.29697 2.2625 8.62223 +3099 6 34.3954 9.09122 20.4203 -0.702674 2.95809 7.47625 +3100 4 33.5897 9.50113 20.7506 -0.63314 5.38769 7.97821 +3101 4 34.107 8.76785 19.5728 -0.194313 -9.82044 -16.4611 +3102 6 18.2164 33.5433 26.5438 32.3972 -29.6611 -30.5808 +3103 4 19.1929 33.4142 26.4527 -23.3283 -2.37285 -6.48837 +3104 4 18.1915 34.0681 27.3044 -13.0981 29.1765 42.7321 +3105 6 28.9207 17.4075 26.7926 -1.66434 -4.11711 9.90999 +3106 4 28.2497 17.0259 26.21 0.151798 0.605301 -3.15085 +3107 4 28.4243 17.7127 27.5796 8.50802 -3.38176 -8.48604 +3108 6 50.4389 35.5612 18.195 -0.220837 -24.3132 -9.08897 +3109 4 50.4331 35.2145 17.2813 -0.853004 14.3463 8.17747 +3110 4 50.3692 34.7248 18.6968 -4.07606 17.1918 3.62275 +3111 6 2.99582 21.5586 31.4575 0.708202 -18.646 -28.6731 +3112 4 3.24926 22.2892 30.8424 -5.67023 -11.8068 12.1364 +3113 4 2.8516 20.7624 30.8616 4.12476 24.3831 20.6408 +3114 6 36.1857 18.7483 8.60511 9.96184 26.1081 -2.68835 +3115 4 36.1356 17.8778 8.93402 3.95956 -36.7917 21.724 +3116 4 35.6171 18.7388 7.85438 -14.2398 9.24248 -24.4438 +3117 6 20.2742 6.47995 33.7286 -0.427153 4.78104 -4.08195 +3118 4 19.8935 6.35632 34.6244 -2.14212 -11.6635 -12.611 +3119 4 20.0876 5.70362 33.1559 -1.45185 1.76636 16.8362 +3120 6 13.9952 30.5211 6.65468 -0.834568 0.374695 7.89925 +3121 4 14.6781 31.0539 7.1149 -10.4447 -7.07426 -7.17019 +3122 4 13.1432 30.7212 7.07951 7.79461 1.02333 -2.73826 +3123 6 36.2732 16.4484 35.7639 18.345 14.0335 0.961522 +3124 4 37.2268 16.2475 35.9495 -24.6333 8.21497 -3.5549 +3125 4 36.1837 17.4253 35.5797 7.74798 -29.1845 4.36862 +3126 6 45.8208 37.6575 9.69399 14.3507 -31.8621 -27.6249 +3127 4 45.4608 38.3019 10.268 -8.06385 16.394 26.7739 +3128 4 46.3975 37.0305 10.1733 -1.81999 10.6315 0.898341 +3129 6 47.4165 17.984 27.6369 4.10759 -46.3966 -5.45297 +3130 4 47.5682 17.4629 26.7823 -7.01073 17.4072 30.8444 +3131 4 47.4562 17.3293 28.4007 0.542452 20.9274 -25.5144 +3132 6 25.9608 18.2932 0.952258 -4.39486 21.5955 18.9376 +3133 4 26.1989 18.9101 1.66086 12.5057 -8.35286 -7.15646 +3134 4 25.0082 18.3237 1.04468 -12.1408 -13.2893 -13.6751 +3135 6 27.3648 22.4066 4.28268 2.26175 -24.9034 0.419816 +3136 4 27.3706 23.3409 4.46802 1.80952 16.8807 -5.51915 +3137 4 27.3027 22.2785 3.32806 -2.77408 5.10873 4.5687 +3138 6 3.39125 3.84856 27.607 3.69966 -10.1033 0.490887 +3139 4 4.0137 4.55908 27.5406 6.78149 24.6072 0.911673 +3140 4 3.97847 3.09168 27.5281 -8.4044 -12.3732 0.103181 +3141 6 45.3633 27.6554 28.8452 2.12727 -1.25659 10.7713 +3142 4 44.5282 27.2015 28.6866 -4.83999 -4.58212 3.48715 +3143 4 45.3811 28.2979 28.14 4.63148 6.41932 -6.37453 +3144 6 28.4005 32.3772 16.2203 23.7034 -3.75626 0.763822 +3145 4 29.2297 32.2225 15.6968 -18.0553 4.16843 14.9752 +3146 4 28.6795 32.6874 17.1033 -0.325788 -1.29005 -11.6373 +3147 6 9.90477 33.835 13.0292 3.70295 -3.7397 30.9684 +3148 4 9.58558 33.3049 13.7992 6.56164 12.5415 -12.6178 +3149 4 9.32425 33.6546 12.2978 -12.2649 -3.83445 -16.8068 +3150 6 38.3301 26.6316 14.917 8.16845 -9.374 -1.40965 +3151 4 38.7482 25.7736 15.154 -10.3234 14.7528 -2.05039 +3152 4 37.3847 26.6122 15.1206 3.66029 -5.29 2.35016 +3153 6 31.3553 16.3729 4.24558 -11.5598 -13.3523 13.2112 +3154 4 30.5395 15.8971 4.54084 13.4071 7.11555 -7.19651 +3155 4 31.205 16.607 3.32285 -2.62497 2.93757 -4.30077 +3156 6 6.17611 3.41063 6.5613 17.7272 3.64487 37.5473 +3157 4 6.46982 3.08663 7.46094 -9.0795 17.2981 -27.883 +3158 4 6.02642 2.6045 6.08389 -2.81663 -13.5692 -12.3872 +3159 6 42.5919 12.9938 5.62253 0.302259 -11.3067 -0.460125 +3160 4 42.3001 13.8766 5.84478 4.87778 6.39543 1.2284 +3161 4 43.5084 12.9049 5.92305 -2.35353 0.46184 -1.33783 +3162 6 41.0467 31.3953 33.7949 3.79599 37.3117 5.16998 +3163 4 40.7289 31.3961 34.7173 5.05156 -5.30154 -15.2916 +3164 4 41.2174 32.3636 33.5809 -4.47671 -37.1445 4.47908 +3165 6 52.8595 12.0576 26.2617 4.7779 -12.5882 -49.4794 +3166 4 52.3971 12.713 26.7564 -13.8804 18.303 15.9364 +3167 4 52.6839 12.2865 25.2977 8.87889 -9.64762 29.5111 +3168 6 39.2197 4.29237 29.0569 11.235 6.95972 3.08537 +3169 4 38.4782 4.84799 29.3396 4.36118 -6.50894 -4.0878 +3170 4 39.9967 4.59393 29.5615 -4.77927 -7.36273 -4.89832 +3171 6 3.64414 27.0065 11.2815 -12.9441 10.9516 -6.43872 +3172 4 4.59106 26.8908 11.2849 14.3058 -9.72403 4.26042 +3173 4 3.53535 27.8319 10.7781 -8.82957 -2.80904 -0.131447 +3174 6 41.5421 29.6442 25.2671 -5.6293 3.19366 2.66863 +3175 4 41.8684 29.6903 24.3723 12.1179 -3.11764 -10.4285 +3176 4 40.7194 30.1326 25.2057 -6.30215 2.63585 1.74894 +3177 6 50.468 27.487 30.6705 -3.05594 -10.4468 2.57161 +3178 4 50.076 27.1594 31.5009 0.806547 4.01213 -5.24181 +3179 4 49.8217 28.0451 30.2184 -2.62753 1.96724 1.87939 +3180 6 32.7902 33.6258 41.7496 -4.87138 -4.97834 -25.0012 +3181 4 33.1641 32.7497 41.8541 3.47816 -11.5824 1.65798 +3182 4 32.8969 34.0586 0.665858 3.16614 12.7166 21.4132 +3183 6 5.9796 9.64598 7.93234 5.57207 13.1841 -10.7861 +3184 4 5.80592 9.95912 8.82583 -0.986272 -0.521215 4.5825 +3185 4 6.43021 10.3852 7.47125 -1.05258 -10.6241 3.31462 +3186 6 52.774 25.3768 27.6816 12.7732 -3.18466 28.0173 +3187 4 52.93 26.2779 28.0237 -8.60677 -10.695 -13.1321 +3188 4 53.2011 24.8527 28.4031 -8.37753 -2.27765 -26.5487 +3189 6 18.6947 23.2095 14.4724 -28.0966 8.43578 15.8218 +3190 4 18.5587 24.1605 14.7523 20.6562 -24.296 -13.1918 +3191 4 19.5669 23.0215 14.1303 11.4888 10.4676 -1.8787 +3192 6 31.2862 9.0706 13.0896 18.8649 -43.5027 -8.26415 +3193 4 31.2854 8.18164 13.5153 -0.98006 14.2242 -7.24428 +3194 4 30.8139 9.64196 13.6614 -21.2648 23.3567 24.384 +3195 6 52.8349 16.8368 29.9626 -1.04236 -5.83632 -3.7224 +3196 4 53.1314 16.3317 29.1809 4.11254 10.2245 6.81583 +3197 4 53.5336 17.4658 30.2088 5.59995 -2.32318 -6.64835 +3198 6 13.48 30.6403 11.9185 -26.7 12.8254 18.6299 +3199 4 12.8874 31.2649 12.4086 6.11749 -21.3055 -11.69 +3200 4 14.2712 31.1662 11.9231 18.3999 3.72963 -5.07782 +3201 6 24.4118 24.6653 11.1776 -11.0488 -38.9105 0.0232616 +3202 4 25.2327 25.0345 11.4834 15.6111 8.28781 8.86477 +3203 4 24.5324 23.6736 11.237 -9.01076 27.817 -2.51724 +3204 6 11.1207 26.7925 5.93063 -6.41259 2.09364 -8.23675 +3205 4 11.5241 26.98 6.79711 -3.12879 8.72791 -6.17468 +3206 4 10.8719 27.6544 5.50988 6.7003 -18.2386 15.7162 +3207 6 12.0069 32.3194 4.56559 -6.93674 1.89769 -53.2748 +3208 4 11.7104 31.8608 3.68045 16.1117 25.2499 46.2442 +3209 4 12.3686 33.2222 4.3326 -9.20365 -26.1492 2.14142 +3210 6 6.43611 5.48582 30.4705 10.9412 7.27018 -5.81208 +3211 4 6.8324 6.31983 30.1884 15.302 -0.761667 0.276275 +3212 4 5.5204 5.70213 30.4126 -22.6187 -2.98333 3.5448 +3213 6 38.1723 39.6045 29.3805 -11.1368 -0.968084 -7.99101 +3214 4 37.5332 40.3179 29.1036 12.1085 -24.1545 -0.917311 +3215 4 37.9804 38.7063 28.9788 -2.28765 36.4506 5.30967 +3216 6 52.5924 19.3736 5.41149 4.12965 0.0949992 -5.17576 +3217 4 52.3027 20.2712 5.07121 22.7239 -28.0308 -2.84369 +3218 4 53.4989 19.0543 5.10701 -28.7609 25.7225 2.66162 +3219 6 18.3561 9.81057 21.0683 -18.476 -24.6523 15.6829 +3220 4 17.6378 9.45854 20.4828 20.1245 14.4878 5.80252 +3221 4 19.033 10.2869 20.5982 6.82627 10.6552 -20.9713 +3222 6 14.5094 41.1238 15.0395 5.73538 -4.06503 -13.1796 +3223 4 15.2839 41.068 15.6075 4.55031 0.900939 7.74817 +3224 4 13.875 41.6599 15.5263 0.0235554 2.15182 4.98288 +3225 6 36.0027 23.903 26.7597 7.48895 21.6763 -35.676 +3226 4 35.8975 23.6043 27.6465 2.36908 -17.7227 17.2904 +3227 4 36.3267 23.2124 26.1374 -7.97178 4.49324 27.7844 +3228 6 35.6359 10.4157 26.2529 -13.2839 -25.1837 23.1485 +3229 4 35.969 10.5098 25.3716 5.3977 0.436992 -21.1808 +3230 4 35.4229 9.45302 26.3798 5.18698 20.1527 -7.56493 +3231 6 45.3037 24.2791 20.2723 9.06075 11.2998 -13.4968 +3232 4 45.4523 24.978 19.6109 10.2075 -1.49386 4.95329 +3233 4 44.5125 23.8555 19.9662 -13.3892 -9.58217 -2.04663 +3234 6 15.8107 39.0453 24.2393 9.7405 19.086 8.48056 +3235 4 15.3407 39.8143 24.6455 3.07287 -17.6695 -6.90152 +3236 4 16.7434 39.3626 24.1878 -22.1708 -8.11019 0.25747 +3237 6 4.61074 25.9041 16.8066 4.47487 12.325 4.32837 +3238 4 5.33363 26.3313 17.2996 -1.16871 -8.95741 -3.63592 +3239 4 3.89121 26.5439 16.91 5.27726 -3.71411 -3.28281 +3240 6 33.4791 9.99232 32.5716 -36.5508 -4.76722 -31.2046 +3241 4 34.3147 10.2419 32.89 39.2476 10.968 21.6954 +3242 4 33.0188 9.57531 33.3002 0.324125 -5.12222 10.2577 +3243 6 22.9388 37.5185 1.51191 -4.27166 -24.2064 8.31852 +3244 4 23.0334 38.2273 2.154 1.20614 3.86272 6.71724 +3245 4 22.69 36.6978 2.02191 6.96614 23.4315 -10.5782 +3246 6 39.1324 20.5485 25.4772 25.265 -11.778 19.9951 +3247 4 39.2103 21.4279 25.1215 -1.526 12.0473 -3.88318 +3248 4 39.8813 20.4818 26.1301 -17.748 -0.0581828 -14.4699 +3249 6 25.0622 25.0762 37.6014 21.4558 5.76047 -13.7935 +3250 4 26.0349 25.2337 37.6294 -19.4467 -8.38624 -4.14531 +3251 4 24.8891 24.8197 38.5048 -7.65564 -1.94532 12.2316 +3252 6 12.209 35.7591 11.4203 -9.12536 1.25056 -5.53999 +3253 4 11.4995 36.2015 10.8899 19.2305 -11.6187 8.3526 +3254 4 12.8486 35.4161 10.7797 -5.71729 7.89629 -2.43108 +3255 6 42.046 15.7235 20.1276 29.9467 5.46844 -26.2367 +3256 4 42.5818 15.5034 19.3148 -14.0105 1.75231 17.5608 +3257 4 42.3615 16.6209 20.337 -4.0808 -2.27778 2.90042 +3258 6 53.2021 25.4307 39.5282 4.69599 -13.2561 7.07883 +3259 4 53.78 25.8541 38.905 5.49131 5.5629 -6.42231 +3260 4 52.4802 26.028 39.6966 -10.1139 9.50655 0.821399 +3261 6 53.7967 21.778 1.29815 15.5744 -8.20383 1.43914 +3262 4 54.6378 21.4326 0.944441 -3.84265 -1.46767 8.18122 +3263 4 53.3536 22.1543 0.542634 -13.037 9.31425 -11.6048 +3264 6 1.93111 22.4438 20.1768 4.00387 4.12813 31.1185 +3265 4 1.5939 23.2361 20.6593 2.49828 -13.4199 -15.2591 +3266 4 2.41139 21.9607 20.8911 -6.34657 6.89732 -14.8434 +3267 6 41.1871 16.1847 11.4932 0.836017 42.0531 1.99799 +3268 4 40.9413 15.3195 11.802 -9.8633 -17.6073 7.87469 +3269 4 40.5377 16.8617 11.8588 16.4331 -27.7799 -8.96912 +3270 6 17.194 38.6096 9.61825 4.75854 -2.20459 -16.4638 +3271 4 17.8324 38.6167 10.328 10.0816 -0.610832 12.429 +3272 4 16.3385 38.6013 10.0398 -14.9506 0.593169 11.9887 +3273 6 33.2005 12.9606 38.531 8.50507 10.8774 -15.8661 +3274 4 33.6532 13.8203 38.39 -7.98235 -13.7359 5.26797 +3275 4 33.1331 12.8007 39.479 5.11874 5.24255 -4.23095 +3276 6 24.7171 21.675 39.9778 2.8762 -23.2501 -10.2076 +3277 4 24.5558 21.597 39.0096 0.45736 0.189324 11.8412 +3278 4 25.3262 20.9394 40.2143 -5.83632 9.86919 -3.30671 +3279 6 13.5803 15.5602 27.3532 26.1047 30.3564 11.1382 +3280 4 13.1676 16.145 28.014 -3.26959 -8.19558 -5.9347 +3281 4 12.973 14.8589 27.1951 -20.4184 -17.1677 1.43072 +3282 6 24.68 18.7128 9.26691 14.3839 36.3501 26.0009 +3283 4 25.3598 19.2552 8.82532 -5.31062 -15.6251 -9.27674 +3284 4 24.5166 19.2286 10.0937 -4.12977 -20.8661 -14.1648 +3285 6 10.971 8.2031 0.0820528 -5.05885 27.6393 52.7366 +3286 4 10.426 8.82187 0.676738 20.6953 -23.692 -21.2054 +3287 4 11.8511 8.19112 0.51746 -10.8092 -0.715691 -8.01276 +3288 6 15.7168 31.9426 31.3882 -16.0589 -14.8784 11.374 +3289 4 14.8784 32.0139 30.9212 -5.19427 4.39929 -5.1125 +3290 4 16.2361 32.7208 31.1626 4.51908 -4.85975 -1.07492 +3291 6 20.3853 39.1678 21.6201 3.96912 1.70678 -2.15463 +3292 4 19.8408 38.4031 21.9136 18.3946 15.2484 5.21077 +3293 4 21.1259 39.3411 22.2478 -18.5683 -14.4588 -3.61544 +3294 6 38.8575 19.5345 7.60357 -3.22682 7.2187 -10.7103 +3295 4 37.9955 19.1157 7.58645 -3.56529 1.50397 -1.646 +3296 4 39.2183 19.2349 8.43232 7.58358 -7.76078 7.45775 +3297 6 41.3566 29.7161 21.1634 -18.4754 -13.1658 17.2704 +3298 4 41.7904 29.7702 20.3348 3.95998 3.00501 -30.3792 +3299 4 42.0386 30.0045 21.7486 9.4821 7.67994 22.7786 +3300 6 50.7055 33.8359 22.0677 10.0235 -14.5617 12.8511 +3301 4 51.0634 32.983 22.4061 -4.7136 19.0099 -8.42991 +3302 4 50.4062 33.6539 21.1646 0.0172424 0.211956 1.78818 +3303 6 18.1576 11.1602 14.3564 -14.1594 -3.53412 4.86119 +3304 4 18.0624 11.3441 15.3149 3.69196 -2.83217 -14.991 +3305 4 19.1071 11.0831 14.1997 2.21718 -0.861887 0.62752 +3306 6 48.509 14.2737 15.2536 -33.8512 -15.7039 -13.3543 +3307 4 49.4102 14.4821 15.4142 31.3042 4.03673 3.1002 +3308 4 48.4635 13.5769 14.5611 0.497508 10.2707 10.4073 +3309 6 32.9892 15.7452 8.24788 15.5762 1.59093 3.47394 +3310 4 33.8184 15.532 7.78513 -5.99942 0.288096 4.45585 +3311 4 33.1922 15.7362 9.20789 -3.05234 -0.622843 -13.6288 +3312 6 42.9176 4.85532 18.7629 14.1748 1.41964 3.40057 +3313 4 42.9882 5.82921 18.9229 4.77982 -22.1758 1.39114 +3314 4 43.8043 4.45344 18.9624 -18.3785 17.0247 -7.93082 +3315 6 10.5031 23.7237 33.4382 -0.874073 19.9298 2.74355 +3316 4 10.5548 24.717 33.3795 7.7257 -28.8706 -7.54496 +3317 4 11.1379 23.281 32.8547 0.735263 11.3428 1.89897 +3318 6 1.13216 20.0583 11.2836 18.374 17.5884 12.1148 +3319 4 0.491024 19.3349 11.1994 -2.17247 3.20995 10.4498 +3320 4 1.13554 20.5377 12.169 -13.4236 -25.5013 -29.3002 +3321 6 1.52072 39.5358 14.3069 -1.86369 -19.4721 11.7014 +3322 4 0.846705 40.1803 14.5938 4.14733 -5.95668 -5.60613 +3323 4 1.29368 38.6598 14.724 6.32152 28.9753 -9.07681 +3324 6 8.31775 21.6111 14.1387 -15.017 -6.93379 31.3726 +3325 4 8.13664 21.1659 15.0266 4.22851 15.111 -30.7591 +3326 4 7.52757 21.5034 13.5919 -1.9589 1.09648 1.01763 +3327 6 7.16491 13.3069 38.2405 -3.91014 1.61314 -29.5843 +3328 4 6.63698 13.0539 37.4502 4.01765 -4.94514 23.7112 +3329 4 7.51249 14.1719 37.966 2.17516 -8.38294 10.659 +3330 6 46.6268 1.62726 18.6981 -5.20766 -2.9114 16.5849 +3331 4 47.5711 1.68468 18.9367 -9.38594 -0.162468 5.90612 +3332 4 46.1191 1.48652 19.5414 20.1897 3.23395 -16.531 +3333 6 4.07867 8.38347 14.797 30.0262 18.9917 2.43531 +3334 4 3.34187 8.3175 15.3794 -25.1937 -7.21885 10.0707 +3335 4 3.92422 7.81173 14.052 -7.87119 -13.0009 -15.9092 +3336 6 47.5843 36.535 17.848 27.4213 12.0237 5.93301 +3337 4 47.2301 35.69 17.6416 -25.9655 -28.1947 -7.00186 +3338 4 48.5203 36.321 17.8356 11.6458 7.4707 2.49139 +3339 6 48.7172 32.6081 3.62434 16.9155 19.6851 -27.3563 +3340 4 49.4676 32.1613 3.18145 -8.8052 -0.0369675 17.0972 +3341 4 48.3534 32.1141 4.33579 -5.12692 -24.8974 22.5299 +3342 6 26.8624 34.4063 15.194 -5.61502 8.38998 -0.355377 +3343 4 27.128 33.6719 15.7603 3.91671 -4.37186 -8.54489 +3344 4 27.3784 34.3384 14.3661 -3.09932 -5.4603 13.6569 +3345 6 9.98983 27.3411 13.3236 -5.30345 -60.6937 -19.0037 +3346 4 9.94192 28.2179 13.0053 -1.51785 37.2293 -13.4128 +3347 4 9.87191 26.7487 12.5139 4.66007 24.2176 27.9858 +3348 6 2.39898 26.8872 37.357 1.59401 -7.29113 19.9813 +3349 4 2.39832 26.7504 38.3162 -5.28205 -0.510768 -0.23331 +3350 4 3.33711 26.9514 37.1904 14.8183 3.44774 -11.9786 +3351 6 33.3368 17.2756 36.8005 -23.2882 7.84328 1.94786 +3352 4 32.371 17.4043 36.8526 5.24602 0.476467 11.7287 +3353 4 33.4423 17.1515 35.8622 12.5187 -3.29866 -15.2334 +3354 6 10.6624 18.8035 9.30575 -3.98781 15.2275 -14.7508 +3355 4 10.7339 18.764 8.32616 -2.59554 -5.92059 15.2764 +3356 4 10.8972 19.732 9.49452 -1.55193 -6.4517 3.37647 +3357 6 8.57833 27.4047 3.14019 -5.09403 -6.13324 -2.85576 +3358 4 8.57126 27.6547 4.08504 -2.7611 -8.03155 -6.83353 +3359 4 8.4622 26.4231 3.09919 3.19624 23.0742 12.9307 +3360 6 40.6073 33.9264 14.3399 -6.85038 20.2562 -23.9123 +3361 4 40.863 33.245 14.948 0.807967 -8.16399 15.1571 +3362 4 40.0779 34.5716 14.8204 -0.495244 -4.69725 4.10141 +3363 6 53.9925 16.7992 13.6308 6.31935 -7.9338 28.1888 +3364 4 54.0997 17.1551 12.7528 -11.031 14.1585 -18.9596 +3365 4 53.1709 17.0486 14.0912 -3.14305 7.59696 -13.573 +3366 6 39.1497 38.4912 7.40608 -39.1223 4.05884 30.5073 +3367 4 38.8859 38.5922 6.48797 -2.00378 4.08479 -3.77896 +3368 4 38.3062 38.5986 7.97667 35.5804 -2.74434 -28.8566 +3369 6 42.2129 33.6808 29.0138 -24.1371 3.42921 -11.8129 +3370 4 42.1057 34.6378 28.7577 -2.98627 -25.8941 0.854821 +3371 4 41.3475 33.1819 28.8496 28.8118 27.0492 8.45917 +3372 6 2.85866 0.0629173 20.1315 -20.2536 1.52979 -19.4947 +3373 4 2.75203 0.421025 19.2221 8.85994 -2.20895 9.93397 +3374 4 1.96017 41.6124 20.299 15.6791 2.4666 6.01858 +3375 6 24.986 26.9373 24.4454 -5.13687 18.0728 7.96565 +3376 4 25.2851 26.0172 24.3926 4.88984 -3.86206 4.04103 +3377 4 25.2923 27.4081 25.2509 0.579281 -17.4573 -11.648 +3378 6 13.6179 33.9875 7.01366 -9.87556 12.4155 -39.0476 +3379 4 14.4287 33.6264 6.65472 5.99816 -4.92128 6.68342 +3380 4 13.2096 34.3429 6.17379 4.4552 -5.00021 31.0775 +3381 6 17.6494 31.8378 3.38868 3.47258 32.8259 -24.0658 +3382 4 17.3179 32.0585 2.49435 6.00696 -1.44586 18.975 +3383 4 17.3532 30.9566 3.5196 -11.0767 -31.773 11.9025 +3384 6 31.1111 29.8483 35.9167 13.6376 7.61418 -14.6842 +3385 4 30.4141 29.611 36.5018 -19.519 -6.65958 16.6428 +3386 4 31.8988 29.4329 36.2727 4.98993 0.410401 2.8928 +3387 6 31.4643 1.69164 1.93808 20.5111 47.6543 28.2436 +3388 4 30.8038 1.05919 1.86135 -35.916 -50.7273 -13.0106 +3389 4 30.9957 2.32106 2.5233 13.9145 -2.66096 -10.7861 +3390 6 13.7147 9.36591 12.3063 -10.8769 -31.3803 3.40225 +3391 4 14.006 10.2311 12.0687 5.19854 25.7457 4.3425 +3392 4 13.2135 9.34561 13.1466 7.78847 9.513 -6.56361 +3393 6 15.2882 15.1512 12.1315 -28.7349 -8.10496 1.75886 +3394 4 14.285 15.1274 12.2085 32.3197 -4.02875 -3.81405 +3395 4 15.5527 14.5676 11.4001 -6.69875 1.91641 1.76342 +3396 6 44.9132 30.4441 13.088 -39.1187 -0.31911 18.6923 +3397 4 45.3561 30.6438 13.8967 -2.95974 2.37903 28.1101 +3398 4 45.6316 30.4633 12.5179 38.3165 -3.24606 -51.9295 +3399 6 35.1465 37.623 24.8576 -14.1582 -15.7359 28.7413 +3400 4 34.5779 38.3725 25.1706 10.6028 -16.3472 -5.82963 +3401 4 34.9593 36.856 25.4995 5.71155 29.9045 -22.7235 +3402 6 43.8948 19.2936 12.9987 -2.30513 -18.2146 13.0469 +3403 4 43.787 18.3102 12.9069 2.76315 21.1578 4.09431 +3404 4 44.375 19.4187 13.8444 -6.58761 -4.34429 -6.9628 +3405 6 14.1971 27.3925 16.8971 2.69526 11.3314 -20.1154 +3406 4 13.4533 26.7979 16.9981 -2.42546 -10.6182 5.16389 +3407 4 14.0783 27.734 15.9851 5.1255 -3.8968 13.4589 +3408 6 5.08574 37.4729 15.7377 1.34169 3.72011 38.8669 +3409 4 5.88395 37.4897 16.2981 -4.65405 2.63162 7.63907 +3410 4 5.46406 37.2335 14.9215 11.9791 -13.9554 -41.5179 +3411 6 35.4862 36.9766 33.2333 -36.83 -5.70901 2.9599 +3412 4 36.4114 37.1444 33.1615 28.5824 10.2327 4.96708 +3413 4 35.1164 37.4942 33.9725 5.15458 -1.79752 -2.84758 +3414 6 6.636 31.7097 32.9848 -22.7133 -7.33235 -24.9389 +3415 4 7.22761 30.9741 32.8206 4.14198 -5.34147 5.16294 +3416 4 6.9999 32.2337 33.6789 14.5784 9.31919 13.8511 +3417 6 31.283 20.2175 25.4647 -9.91499 -1.61286 9.73388 +3418 4 30.5344 20.24 26.1037 18.6204 0.149313 -5.83605 +3419 4 30.8734 20.4846 24.6365 -0.167457 4.09649 -2.99843 +3420 6 54.9487 26.0868 7.35258 -28.6285 -0.216784 1.76255 +3421 4 54.2955 26.5615 6.794 6.74078 -5.97369 7.99882 +3422 4 54.4034 25.6757 8.0611 9.89476 6.61779 -10.5703 +3423 6 17.8651 35.1614 24.3791 -20.7499 -4.98646 -29.5673 +3424 4 18.0576 34.6235 25.1649 -8.37985 -1.7243 -11.1178 +3425 4 17.2007 34.681 23.779 26.831 10.1018 28.2803 +3426 6 49.1285 3.31358 19.7417 -8.45795 -3.91869 -17.1851 +3427 4 48.8119 4.11203 20.1653 -3.29153 9.9905 4.05996 +3428 4 49.7807 2.96094 20.3466 4.32541 -4.85853 3.16639 +3429 6 30.2844 35.6035 13.4934 7.2001 -0.317469 -2.452 +3430 4 29.4623 35.659 12.9857 1.71884 -1.71824 2.45729 +3431 4 30.0585 35.4328 14.4204 -4.00669 1.3983 -5.34585 +3432 6 43.3887 25.8808 41.6785 -22.9069 -12.3923 -2.55701 +3433 4 43.9997 25.6768 40.9817 12.0928 0.211006 -14.0269 +3434 4 43.8339 26.4255 0.397834 14.8568 14.8319 19.2759 +3435 6 21.0884 23.1529 6.38678 -1.35916 1.28851 13.8592 +3436 4 21.4 23.8645 6.98768 -5.78702 -12.5756 -9.70729 +3437 4 21.3246 23.4545 5.51028 2.40121 5.3387 -13.5131 +3438 6 54.6143 21.1989 19.0895 1.0726 18.3039 13.0104 +3439 4 0.43531 21.5582 19.5367 -15.0683 -8.68203 -12.1911 +3440 4 53.867 21.7044 19.4937 16.3508 -9.47613 -7.9193 +3441 6 13.877 38.9443 18.7624 -3.57764 -10.5141 -5.7706 +3442 4 13.4493 38.4672 19.4981 1.6116 7.10734 -3.21136 +3443 4 14.0821 39.8514 19.0249 -5.40993 2.00969 6.25434 +3444 6 39.1872 2.73234 39.6824 0.14108 0.727177 -8.14712 +3445 4 38.529 2.27328 40.2354 4.03816 -1.16808 -5.22543 +3446 4 39.0548 2.41866 38.7627 -6.48078 -0.982324 12.2661 +3447 6 43.2185 33.8148 8.84061 -19.4182 46.8926 -2.36482 +3448 4 43.1772 32.9719 9.24022 -1.50187 -35.3898 17.2737 +3449 4 42.5163 34.3616 9.29053 19.0727 -15.0644 -10.6104 +3450 6 23.089 16.6827 12.1027 15.7208 -3.2574 -7.89972 +3451 4 23.4385 16.1911 11.3228 -11.6069 8.24456 13.4993 +3452 4 22.136 16.8018 11.9813 0.424679 -1.38664 -3.29845 +3453 6 40.7855 26.1389 36.3196 -19.9126 19.309 9.87347 +3454 4 40.0986 26.8534 36.2514 19.4153 -21.5003 1.38126 +3455 4 41.1517 26.0031 35.4437 4.25962 0.995192 -8.54639 +3456 6 15.1503 11.6717 19.2973 0.724699 -1.19191 17.6918 +3457 4 15.5299 12.2877 18.6792 5.27756 8.7759 -18.41 +3458 4 15.4868 12.0294 20.1269 -4.65024 -4.08223 3.58338 +3459 6 9.86165 29.8154 31.387 -8.94942 -10.7424 5.06077 +3460 4 10.5846 30.1184 31.9716 0.245343 7.83947 -17.0155 +3461 4 9.856 30.1645 30.4637 12.8302 0.479173 21.4055 +3462 6 2.12473 30.035 25.2763 1.78753 8.3758 2.85176 +3463 4 2.08519 29.2167 25.7943 1.54705 3.16986 -12.4779 +3464 4 2.12365 29.8679 24.3136 0.147535 -6.31004 19.3474 +3465 6 49.0081 10.6471 7.05663 3.22839 15.7191 0.010386 +3466 4 49.8069 10.5015 7.59507 -11.7369 -5.9273 -2.35907 +3467 4 48.4474 9.86293 7.09337 3.15572 -10.0552 5.75386 +3468 6 38.6524 34.4248 32.4903 14.0617 12.8107 -4.97275 +3469 4 38.3124 35.2999 32.7524 2.4491 -7.54743 -1.61947 +3470 4 38.3152 33.7696 33.1015 -5.90625 -1.07654 6.02858 +3471 6 24.2925 24.7077 4.76791 -9.60212 12.423 13.627 +3472 4 24.6592 23.9059 5.14091 6.4374 -12.2494 -4.05598 +3473 4 24.0877 25.2629 5.55261 2.76703 -5.61196 -18.2913 +3474 6 44.0394 23.5955 33.7722 -22.1761 -10.7316 25.8053 +3475 4 43.54 23.0408 33.1405 14.8275 10.6039 0.934173 +3476 4 44.7909 24.0173 33.3845 18.136 8.68259 -21.6513 +3477 6 45.1404 31.9557 26.6336 7.63501 -16.8517 -19.5705 +3478 4 44.7419 32.078 27.4825 -5.98757 6.26965 19.5048 +3479 4 44.9572 31.0195 26.4087 0.928196 13.8489 4.22851 +3480 6 52.067 6.35346 22.8527 -23.4258 -19.9992 -0.226773 +3481 4 51.4359 5.65775 23.1792 22.6487 15.1416 -4.78776 +3482 4 51.473 7.11391 22.7826 5.97124 1.02094 -2.8274 +3483 6 5.11659 17.7141 30.4608 -43.6072 -14.7819 8.36724 +3484 4 5.56343 17.5578 29.6371 20.9412 3.52217 -11.7922 +3485 4 5.63141 18.2128 31.0754 22.7819 13.5036 5.79607 +3486 6 48.537 17.0137 6.52887 28.2349 12.1042 -25.3981 +3487 4 48.2628 16.1023 6.56372 -5.81913 -12.4107 2.5618 +3488 4 49.2494 17.0592 5.82246 -25.6562 2.24824 21.9849 +3489 6 13.808 31.3142 23.4689 -3.64011 -9.68131 26.3432 +3490 4 14.1349 31.2178 24.3617 -12.0329 4.75192 12.2102 +3491 4 14.6149 31.173 23.0226 30.8248 -5.26015 -34.1434 +3492 6 28.4946 33.4369 26.0285 16.4638 25.2333 -6.25798 +3493 4 28.7216 32.7387 25.4298 8.48672 -9.67688 -13.795 +3494 4 27.7897 33.0868 26.5316 -24.4903 -9.494 23.2581 +3495 6 9.0435 22.9594 11.008 21.162 0.605596 1.29652 +3496 4 9.33306 22.7779 10.1087 -4.82127 0.713158 -4.26872 +3497 4 9.8456 22.7632 11.5172 -9.5186 2.48902 2.0044 +3498 6 40.5545 4.06728 26.5809 44.6249 -53.7912 6.90123 +3499 4 40.0988 4.06982 27.4038 -17.0162 4.47424 24.8249 +3500 4 40.1579 4.71783 26.0744 -31.5116 46.4114 -32.7723 +3501 6 17.0554 37.9737 20.9489 23.2001 5.84937 -15.1211 +3502 4 17.8184 37.6206 21.4529 -18.1961 -0.773306 2.14347 +3503 4 16.241 37.9215 21.4323 -8.54619 -6.77157 16.0583 +3504 6 31.9589 6.36634 14.2007 -32.7312 -5.18635 1.31695 +3505 4 31.6173 5.45206 14.3159 2.63352 8.72785 -2.4018 +3506 4 32.9006 6.25378 14.1536 18.2531 -4.45925 -0.605861 +3507 6 29.3682 34.9487 39.6588 1.61784 2.82525 -17.5597 +3508 4 29.3689 34.7576 40.5935 -6.77547 -0.101859 12.4897 +3509 4 28.4273 35.0463 39.4168 8.43037 -3.37269 4.33216 +3510 6 22.5699 2.93494 32.1141 -1.63629 -8.86743 4.25418 +3511 4 23.0898 3.67063 31.7669 1.49018 1.71101 -1.29845 +3512 4 22.818 2.15292 31.5827 -1.92581 11.5593 5.09528 +3513 6 51.7444 19.0899 24.8018 18.5566 14.3159 27.8709 +3514 4 52.1262 19.3991 25.6728 -16.855 -8.06891 -29.5747 +3515 4 52.1578 19.634 24.1129 -3.61196 1.33098 2.20453 +3516 6 32.1137 13.664 24.2226 6.2567 1.72658 -37.8727 +3517 4 32.2307 13.7857 25.1378 6.97488 6.10606 45.7276 +3518 4 31.1794 13.5551 24.0935 -22.8325 -3.39176 -1.92521 +3519 6 9.48788 30.1788 28.8037 -7.90151 -0.480281 -10.0021 +3520 4 9.04214 29.3907 28.4657 0.296662 -4.58444 4.12418 +3521 4 9.71381 30.648 27.9899 1.85323 2.91474 4.33114 +3522 6 31.3027 3.12343 24.087 3.70677 4.08208 -3.18372 +3523 4 30.8363 3.94541 23.9161 -7.21645 -1.79011 2.75115 +3524 4 32.1629 3.26377 23.6687 3.35255 -5.74571 3.4439 +3525 6 2.14326 19.8385 36.4613 43.5578 -10.0216 -16.9659 +3526 4 3.05142 19.7594 36.0352 -31.8637 8.98539 19.2185 +3527 4 1.69253 19.0555 36.1346 -14.6763 0.545221 1.96285 +3528 6 36.957 16.7591 14.0918 2.96563 -13.2358 -6.51153 +3529 4 37.0513 17.1687 14.9682 1.23982 -3.45998 -2.6752 +3530 4 37.3406 15.8552 14.1067 -4.20166 12.9403 2.86695 +3531 6 1.82327 11.1921 6.0808 -0.275886 9.47834 -4.04825 +3532 4 1.66503 10.3513 6.51275 0.636708 -7.94921 -0.277572 +3533 4 1.41092 11.8149 6.68093 -3.53423 6.76721 2.7814 +3534 6 43.1526 36.8455 25.2619 -8.14588 -11.3328 3.19442 +3535 4 42.3648 36.774 24.6888 4.17675 -0.750929 11.0286 +3536 4 43.0263 36.2034 25.9927 3.18182 11.8936 -13.2388 +3537 6 32.1279 5.54767 7.01242 2.49094 2.37791 -5.83138 +3538 4 31.9279 4.68363 7.38152 0.218816 -4.41428 4.71371 +3539 4 31.563 6.18782 7.45455 -6.02642 2.24751 5.27561 +3540 6 15.066 21.4965 41.5173 26.6113 -14.2353 0.879596 +3541 4 14.4098 21.4318 0.299313 -13.8163 5.2854 1.00244 +3542 4 14.7314 21.9782 40.7628 -14.3918 6.6959 -6.38566 +3543 6 37.0263 36.0654 5.67599 -8.66989 11.0394 5.08886 +3544 4 36.7926 36.9074 5.26668 1.42879 3.21556 -9.50708 +3545 4 36.6993 36.1724 6.58455 6.67811 -8.44617 -2.15326 +3546 6 39.6264 22.8802 0.345968 -6.61229 0.0560669 1.87747 +3547 4 39.9979 23.7083 41.9266 1.97423 1.58642 1.0556 +3548 4 39.8106 22.8717 1.30105 -0.716498 -2.72173 1.5866 +3549 6 18.4762 23.1875 5.24196 -3.43754 -16.0644 -0.1002 +3550 4 18.2109 24.0785 4.97873 9.26343 12.8459 2.1419 +3551 4 19.3202 23.1705 5.73113 -5.23082 11.7415 -3.58503 +3552 6 34.4866 26.3931 0.410981 -26.1443 -19.9516 50.1306 +3553 4 33.9706 27.0567 0.94736 13.8106 -10.3269 -20.7381 +3554 4 34.4077 25.5868 1.01915 10.7474 25.1704 -28.4611 +3555 6 28.1474 26.0925 40.6196 -28.5345 -18.6936 36.4955 +3556 4 29.0529 26.0026 40.9247 9.18224 2.32741 -2.79367 +3557 4 27.6107 25.644 41.3519 15.6172 17.8969 -31.6189 +3558 6 41.7482 4.39863 30.2421 -5.41295 4.8086 27.4354 +3559 4 42.5847 3.93131 30.2216 8.80522 -6.59194 -7.61494 +3560 4 41.6924 4.68152 31.1831 -5.94926 -0.146025 -12.4776 +3561 6 4.45598 8.30655 29.1222 20.5127 -16.5965 8.52389 +3562 4 3.66946 8.7156 28.7677 -9.60933 13.4518 -0.978151 +3563 4 4.96147 8.97819 29.6123 -10.8114 0.933443 -7.64816 +3564 6 12.9096 9.61234 32.1411 7.95239 -11.3181 7.67023 +3565 4 12.5174 8.82681 31.7782 -9.40951 -4.97415 -8.25208 +3566 4 13.381 9.26623 32.9076 3.83436 11.6436 3.42456 +3567 6 48.6608 16.2478 1.44826 -41.5847 5.12436 -2.24268 +3568 4 49.5977 16.2655 1.51923 27.6715 2.95254 13.2549 +3569 4 48.2356 16.5221 2.2956 18.9339 -8.30142 -14.6437 +3570 6 26.4307 40.0076 21.1903 -9.81311 41.2665 6.04236 +3571 4 27.1749 40.6498 21.1967 -8.04845 -12.0635 0.822588 +3572 4 26.7755 39.1508 21.0026 13.0624 -20.4442 -2.17563 +3573 6 35.79 4.08177 9.00682 -31.6066 0.334495 -4.41207 +3574 4 35.483 4.74976 8.36033 1.0784 -4.66377 5.72074 +3575 4 35.0087 3.86601 9.59196 22.2264 5.21899 -16.6494 +3576 6 52.6895 3.55332 27.8634 16.2443 -8.90238 -17.7273 +3577 4 53.4861 3.5089 28.4695 -19.2533 -5.0216 -23.8454 +3578 4 52.9436 3.34738 26.8904 -3.28408 11.0051 45.9059 +3579 6 48.3169 26.6974 27.3926 25.9077 -23.6746 5.28014 +3580 4 49.0048 25.9927 27.5456 -25.7263 19.495 -6.18754 +3581 4 48.6886 27.4598 27.8411 -2.12981 11.4596 4.51315 +3582 6 24.5097 4.95686 18.7286 -11.1396 -9.34012 13.2359 +3583 4 24.0942 4.18073 19.1756 8.31772 16.1923 -9.35863 +3584 4 23.9484 5.73893 18.8892 6.66511 -10.1227 -0.689949 +3585 6 24.0567 12.4804 28.7686 -1.83015 0.889486 -1.95598 +3586 4 23.1997 12.8888 28.9043 -2.54864 9.49841 4.61676 +3587 4 23.8244 11.6446 28.3683 7.90245 -6.62953 -5.67748 +3588 6 40.1561 27.7426 40.8073 -21.5317 7.14576 -7.35733 +3589 4 40.4932 26.962 41.2601 -12.917 0.0491148 -0.726507 +3590 4 39.1936 27.5721 40.6401 25.9681 1.33069 1.19471 +3591 6 11.9274 13.5458 26.9496 -4.40765 -1.96337 -6.60028 +3592 4 10.9986 13.6678 27.167 -4.51497 -1.32563 0.190923 +3593 4 12.2404 12.8654 27.5442 6.31176 -11.0874 3.59056 +3594 6 52.1902 29.5387 41.394 18.594 -11.3781 3.59259 +3595 4 51.989 30.3087 0.0068425 -9.85392 15.5397 4.91192 +3596 4 53.1003 29.3208 41.6912 -5.64389 -6.04423 -8.59676 +3597 6 17.4867 19.0227 39.1838 -6.27455 21.666 2.75279 +3598 4 17.488 19.586 40.0024 0.860103 -14.9947 -21.9977 +3599 4 17.2876 19.5951 38.4014 5.36511 -12.0476 21.2649 +3600 6 46.2283 27.6807 33.7144 -6.74129 13.676 11.5468 +3601 4 46.0876 28.3582 33.0447 4.86435 -1.49715 -10.0026 +3602 4 45.6533 27.9743 34.4365 0.457797 -3.70748 6.99028 +3603 6 35.8353 29.5439 5.61992 2.49906 -1.59566 -19.7219 +3604 4 35.6527 29.5233 4.66367 4.90114 -0.621078 3.19465 +3605 4 35.4473 30.3766 5.88547 -3.82587 11.7884 10.6864 +3606 6 47.2822 25.7798 30.1513 -10.5766 8.53329 -17.9568 +3607 4 48.1664 25.813 29.7363 -13.2628 3.84456 1.19765 +3608 4 46.6616 26.387 29.6551 21.0058 -12.1546 6.47151 +3609 6 51.3953 12.3638 20.0228 -1.62023 8.46277 -4.73872 +3610 4 50.7529 12.7462 19.4094 4.65296 3.97806 -1.37635 +3611 4 50.8736 11.6867 20.4477 2.10356 -10.8225 11.04 +3612 6 41.9857 18.3757 28.9464 12.9674 -8.39178 -20.9845 +3613 4 42.6678 18.0249 28.3214 -8.5661 8.58724 12.8041 +3614 4 42.4509 18.9846 29.5329 1.95722 -2.13958 -2.01301 +3615 6 53.5955 6.47736 7.49747 -17.4879 -34.0434 -11.6994 +3616 4 53.215 5.56736 7.34717 12.2612 27.0176 1.32153 +3617 4 53.8473 6.47025 8.42428 8.27981 0.813073 3.28926 +3618 6 9.90701 10.6092 26.7593 2.25524 -7.80823 -0.160956 +3619 4 10.2937 10.2906 27.6083 -8.74192 13.2514 -11.8083 +3620 4 9.6719 11.5504 26.8324 5.3909 -8.28719 7.73453 +3621 6 9.32838 39.4044 29.7661 28.1478 19.087 17.9947 +3622 4 10.1636 39.3682 30.3277 -29.6144 2.71186 -18.0569 +3623 4 8.79772 40.1574 30.1092 9.7156 -13.1012 -9.05156 +3624 6 33.3969 4.77935 0.0338577 7.04977 -8.48101 -1.75146 +3625 4 33.7652 5.5373 41.4968 -3.54645 16.0087 -2.35532 +3626 4 34.1271 4.15493 41.8774 -6.76144 -3.49152 6.70786 +3627 6 35.7118 10.6691 34.2465 30.5451 -20.2214 -10.6481 +3628 4 35.199 10.7815 35.0349 -14.696 6.44481 20.012 +3629 4 36.4515 10.0721 34.5187 -16.7263 14.6249 -6.06398 +3630 6 15.1941 17.3851 19.1797 2.70911 -28.1342 -44 +3631 4 15.4897 16.9339 18.3047 -12.3876 19.7973 41.7399 +3632 4 14.2542 17.5546 19.0074 0.407714 2.19657 2.29796 +3633 6 17.478 37.6645 15.4329 -18.9254 1.45878 17.8737 +3634 4 16.9549 37.8023 16.2867 26.4617 -7.60783 -22.0624 +3635 4 18.4074 37.4659 15.6333 -6.79317 3.25497 7.31584 +3636 6 26.2497 8.20945 21.7084 13.406 8.66037 11.1677 +3637 4 26.4123 8.51714 22.643 -13.4745 -7.28424 -22.9055 +3638 4 25.3027 8.1176 21.5293 -5.49097 3.27453 10.4234 +3639 6 0.34 9.90937 15.4047 -28.932 15.8312 -5.67551 +3640 4 1.21626 9.57115 15.2747 8.47529 -16.8828 -5.88536 +3641 4 54.6903 9.41637 14.8207 22.8064 6.49071 10.4803 +3642 6 13.4564 40.6532 9.29599 -22.1307 -5.15585 -0.326819 +3643 4 12.4714 40.4452 9.30279 34.033 7.20134 3.90171 +3644 4 13.9359 39.9749 9.79874 -9.44555 -0.536228 -2.64909 +3645 6 49.5525 25.9167 33.0087 8.30289 -20.978 36.7812 +3646 4 50.1102 25.581 33.7998 -31.2394 16.5759 -41.6702 +3647 4 48.6381 25.5592 33.0807 18.1841 3.33668 -0.378289 +3648 6 37.0921 40.0433 26.4323 -69.9693 32.9093 31.9949 +3649 4 36.1848 39.6472 26.7001 50.2617 0.87061 -16.3943 +3650 4 36.887 40.9984 26.66 23.4133 -30.5831 -16.8038 +3651 6 47.9876 17.8592 12.1588 -8.21233 14.3088 -32.1086 +3652 4 47.5845 18.6288 11.6747 8.44083 -19.6159 16.8154 +3653 4 47.7143 17.8826 13.0665 -7.39134 3.08395 19.3289 +3654 6 27.9663 29.0642 34.1603 1.53587 -18.0299 -1.74725 +3655 4 28.882 28.804 34.3498 -7.37789 1.41773 -2.30399 +3656 4 27.9529 30.0159 34.1809 1.22694 21.8088 1.61581 +3657 6 34.0029 2.78452 13.2168 -24.1529 16.185 8.10865 +3658 4 33.6393 2.32953 13.9926 -4.91269 2.52718 -2.68734 +3659 4 34.7844 2.29731 13.0428 30.2788 -14.7346 -8.06408 +3660 6 28.44 36.053 11.4482 -19.9886 -0.916941 20.5685 +3661 4 28.0041 35.3416 10.9605 0.296796 1.69001 -2.92558 +3662 4 29.0597 36.4216 10.8465 18.9417 8.99323 -20.1084 +3663 6 36.1834 11.364 28.8528 2.80179 -1.8504 -16.6465 +3664 4 35.2026 11.3648 28.9433 17.0081 -1.44193 -10.527 +3665 4 36.4266 11.2403 27.8881 -16.5332 2.0664 24.3605 +3666 6 24.8155 39.488 16.899 1.95651 8.69094 -17.2938 +3667 4 24.2729 40.277 17.0547 2.68209 -2.76325 7.28198 +3668 4 24.7648 39.3887 15.9322 -0.898649 -0.731043 6.96785 +3669 6 49.9432 8.0514 22.8505 -60.8038 -24.1516 -13.0827 +3670 4 49.7668 7.94962 23.7845 10.2147 3.57848 16.1239 +3671 4 49.0378 7.75433 22.5026 41.2245 11.1916 1.13457 +3672 6 52.0935 19.338 10.2277 12.6357 -4.19253 18.0692 +3673 4 51.6063 19.2592 9.39778 1.74616 10.4418 -3.52762 +3674 4 52.4735 20.2434 10.294 -12.5007 -15.5081 -12.5544 +3675 6 24.8386 15.8838 6.12895 -18.3448 14.0073 -0.236232 +3676 4 24.2024 16.3229 6.74681 14.2411 -11.6767 -8.77744 +3677 4 24.4989 16.1625 5.25788 7.11766 -3.93298 6.13727 +3678 6 49.3148 23.6851 8.6303 24.9689 -39.379 16.691 +3679 4 49.2746 22.9584 9.31909 -7.63259 29.9964 -23.4819 +3680 4 48.4638 24.0489 8.3953 -15.5352 0.433996 3.53825 +3681 6 0.208059 10.6481 32.1797 22.1875 -2.28391 4.69689 +3682 4 1.08388 10.2912 32.3483 11.827 -2.86298 -20.6213 +3683 4 54.878 10.581 33.0649 -30.4469 3.74284 18.7822 +3684 6 12.5874 32.9143 13.2407 -35.4131 4.94433 4.95913 +3685 4 11.7345 33.4182 13.1185 22.1299 -14.9844 2.19911 +3686 4 13.2795 33.4792 12.9271 13.1216 10.0242 -5.44208 +3687 6 21.734 32.5657 14.1089 -30.2641 -10.609 17.8788 +3688 4 21.1735 33.3586 14.1938 13.4775 0.171544 -7.80997 +3689 4 21.2373 31.9121 14.6504 18.4585 12.3126 -12.4653 +3690 6 48.1656 34.8484 27.3207 -34.4178 -12.3509 -32.6658 +3691 4 47.5287 35.1179 27.9926 9.598 2.53078 9.45385 +3692 4 47.5616 34.4813 26.6056 29.2581 12.2879 19.461 +3693 6 45.6153 31.2627 36.0943 -37.261 16.4569 21.0579 +3694 4 45.7916 31.8927 35.3904 -0.807743 4.61331 -8.81752 +3695 4 44.8366 31.6277 36.6156 19.759 -7.25665 -17.1647 +3696 6 46.2873 0.296503 14.3622 0.346279 -8.22198 0.0964187 +3697 4 46.2502 1.23933 14.2464 -13.6881 13.1616 4.37405 +3698 4 47.2018 42.0236 14.1712 14.709 -12.2876 -2.23521 +3699 6 14.3299 18.994 40.2006 -30.7379 -32.6603 -9.06287 +3700 4 14.4791 19.2338 39.2972 7.93482 8.11578 -14.4624 +3701 4 14.6855 19.6458 40.7662 17.9566 28.0241 18.1173 +3702 6 14.5596 1.14026 10.2341 26.3279 -2.23148 -9.5451 +3703 4 15.4055 1.22344 9.73443 -17.3894 7.51472 10.761 +3704 4 14.1379 0.381418 9.8097 -7.55267 -3.97863 3.86231 +3705 6 34.4334 40.9199 12.9894 -0.940803 4.29697 -17.7271 +3706 4 34.039 40.5607 12.1545 5.82782 2.6847 22.9711 +3707 4 34.273 40.3011 13.7266 -2.01031 0.481385 -16.696 +3708 6 42.1477 25.6267 33.9881 24.0417 -24.4569 -2.75436 +3709 4 41.6299 25.3559 33.2134 -0.0206438 0.202706 6.41118 +3710 4 42.855 24.9213 34.0976 -22.0628 21.5276 -5.85955 +3711 6 29.1852 22.5895 40.0737 -4.6165 -6.65381 -10.571 +3712 4 28.5947 23.1672 39.581 -0.582997 4.41945 3.85107 +3713 4 29.0675 22.7332 41.0074 -2.93269 3.94269 10.2267 +3714 6 44.8062 18.6252 1.49818 5.72139 3.58279 15.6322 +3715 4 44.9314 18.8801 2.44529 -3.9019 -2.65234 -18.9387 +3716 4 44.0985 19.1782 1.14518 3.29812 2.13948 3.69359 +3717 6 4.47265 10.8135 23.9407 -24.2902 -18.4562 11.3409 +3718 4 5.11906 11.4142 23.6391 22.3407 21.5355 -19.7447 +3719 4 4.51291 10.8829 24.8932 -6.80118 0.381125 6.4492 +3720 6 6.46087 23.0097 28.9948 -0.180046 29.3158 3.74757 +3721 4 7.16357 23.1777 29.6697 -12.977 -15.1924 -17.9731 +3722 4 6.42476 22.0762 28.8013 7.623 -17.0728 6.50296 +3723 6 39.796 25.1427 32.5747 9.70804 -1.04373 -32.2987 +3724 4 39.5377 25.4516 33.4106 -12.9416 11.3784 38.6909 +3725 4 39.6539 25.9218 32.0211 1.09764 -5.16827 -8.54386 +3726 6 40.8629 21.4836 8.86543 0.741147 13.6451 -7.24725 +3727 4 40.6441 21.3431 7.92826 2.29745 -6.5969 8.98303 +3728 4 41.3236 20.7041 9.20266 3.81714 -8.25026 -3.81722 +3729 6 0.635293 1.4289 12.9408 -11.8573 10.3167 -17.0811 +3730 4 54.7874 1.76314 12.6159 9.08744 8.74788 -10.2417 +3731 4 0.270536 0.805051 13.547 10.8795 -21.9384 23.5147 +3732 6 32.6734 29.7199 23.4842 -6.31159 -22.9731 3.95312 +3733 4 32.3164 28.805 23.472 7.37478 14.3791 4.20759 +3734 4 32.5291 29.9779 22.5736 0.738758 10.2783 -10.1223 +3735 6 12.5322 37.1564 20.4866 30.6876 51.3804 29.6269 +3736 4 13.0449 37.1468 21.3313 -10.4644 -1.04639 -16.0138 +3737 4 12.1935 36.3015 20.3752 -17.5174 -49.5479 -6.43685 +3738 6 13.879 14.5208 24.6979 -2.0089 -0.488943 14.0828 +3739 4 13.5126 15.2415 24.1863 -2.86121 7.01781 -5.24136 +3740 4 14.0435 14.8889 25.5812 -0.885703 0.504049 -6.33424 +3741 6 17.5084 27.0547 26.4789 25.7109 3.2743 -38.4356 +3742 4 17.3703 27.9297 26.0618 -4.07905 -12.769 13.7294 +3743 4 18.1097 26.6273 25.8042 -17.4354 5.34049 24.3014 +3744 6 54.4807 9.52867 26.3526 -8.08409 11.5192 21.059 +3745 4 54.0543 10.3952 26.5681 7.59002 -15.9534 -5.94965 +3746 4 54.8701 9.18952 27.1901 -5.85154 7.09102 -14.0848 +3747 6 33.6811 21.5047 24.9231 9.13792 -2.03882 -43.3211 +3748 4 33.6373 21.3676 23.9235 3.71376 4.25849 32.7793 +3749 4 32.846 21.1613 25.2346 -13.4677 -6.75943 10.2286 +3750 6 22.147 35.267 2.89295 -1.50127 3.24452 17.3348 +3751 4 22.2381 34.4 2.47628 0.948748 -2.82555 0.0189077 +3752 4 22.0999 35.1233 3.8735 0.523717 -2.91888 -18.7193 +3753 6 45.3111 5.3951 15.6139 -0.0233827 -18.9082 29.3701 +3754 4 45.1442 5.22798 16.5663 9.63366 2.6406 -14.7931 +3755 4 44.5125 5.84005 15.3428 -8.81534 4.22624 -14.6387 +3756 6 5.67663 7.59044 16.9735 -0.040306 4.08799 -12.5895 +3757 4 5.28026 7.88599 16.128 7.47401 -1.2917 10.5251 +3758 4 6.58383 7.937 17.01 -0.793937 -3.87211 -2.68331 +3759 6 34.58 39.0977 27.2045 1.42769 14.436 -3.31523 +3760 4 34.2907 38.4975 27.863 -0.77861 -26.0942 16.6839 +3761 4 34.0642 39.8725 27.4397 -1.42861 13.6713 -5.6929 +3762 6 32.7657 33.6085 34.293 -22.4583 20.5671 -18.6673 +3763 4 32.1806 34.0441 33.6111 23.9751 -17.2665 15.818 +3764 4 32.4638 34.0082 35.1245 2.30326 -6.42306 -1.86009 +3765 6 30.988 41.2133 32.384 -4.02481 -7.82035 -3.95856 +3766 4 30.2267 41.2202 32.9774 -4.32902 6.50081 -0.328838 +3767 4 31.0509 0.17511 32 -1.2051 10.1503 -2.92525 +3768 6 7.6493 1.59177 27.1464 22.3535 -22.6118 -16.4669 +3769 4 8.41104 1.29664 26.5499 -29.8997 15.2665 16.3611 +3770 4 7.54328 2.53873 27.061 4.65755 9.49162 -4.22239 +3771 6 0.888965 22.101 37.8501 15.4112 -23.8094 -16.9331 +3772 4 1.26739 21.3109 37.3638 -11.0686 24.0488 15.8162 +3773 4 1.18 22.8712 37.3372 -1.61814 -2.27923 2.93708 +3774 6 7.39632 11.121 19.2332 -2.86932 4.41375 3.62624 +3775 4 7.58751 12.0436 19.3904 -7.23274 18.3647 6.41875 +3776 4 8.29083 10.7877 19.1848 5.97481 -12.1861 -3.76707 +3777 6 43.7816 12.5054 37.3126 2.86093 2.78929 -1.28281 +3778 4 43.9727 12.4749 36.3586 -3.06612 0.785718 5.83621 +3779 4 44.6572 12.6706 37.7021 -4.14278 -2.20963 -1.61523 +3780 6 29.0947 33.5132 36.1777 7.61955 17.1376 -26.1106 +3781 4 29.8261 34.0815 35.8667 -13.5031 -6.20718 4.51186 +3782 4 29.4784 33.1216 36.9462 10.9925 -12.9866 20.6523 +3783 6 14.807 4.60084 3.93512 20.0881 9.19657 -13.3363 +3784 4 14.316 4.04064 3.33426 -13.0632 -7.60853 1.79497 +3785 4 15.6236 4.79338 3.42413 -10.111 -0.253003 10.8348 +3786 6 39.0437 6.41097 6.40143 -11.952 4.4329 11.9095 +3787 4 39.4604 7.16771 6.02322 8.12547 27.0605 -0.357881 +3788 4 39.3566 5.75952 5.7919 -0.567413 -21.3616 -5.48613 +3789 6 22.2146 37.9992 40.767 -9.02066 -17.4896 -19.1754 +3790 4 22.494 38.8839 40.5618 6.85259 22.4587 -5.93601 +3791 4 22.4583 37.8811 41.6743 4.99519 -4.33654 23.0463 +3792 6 4.4524 23.286 6.15211 29.8095 -7.21279 -13.1375 +3793 4 3.81791 23.938 6.45512 -14.4589 -6.71938 9.72163 +3794 4 4.31449 22.3781 6.49744 -8.68344 13.1635 4.00749 +3795 6 12.4271 23.7748 9.24631 -1.26755 4.43152 21.3749 +3796 4 11.5607 23.6235 8.88266 -11.7175 -2.77193 -9.11925 +3797 4 12.2509 24.3149 10.0432 11.3809 -1.60307 -13.9136 +3798 6 46.4989 15.2625 16.9679 -12.8481 -2.49131 10.8408 +3799 4 47.085 14.9252 16.2779 8.49272 6.07271 -3.86524 +3800 4 46.8927 16.0486 17.3753 9.61298 -1.72862 -3.23202 +3801 6 34.1182 27.164 19.7815 17.9289 -11.392 6.58771 +3802 4 34.8637 26.5005 19.7508 -17.7467 14.3364 5.12367 +3803 4 34.0077 27.4664 20.702 3.31322 -6.80894 -12.4792 +3804 6 46.9518 13.2225 35.1059 11.5726 -0.299351 34.0182 +3805 4 47.3951 14.0533 34.9197 -1.30218 2.22738 -12.772 +3806 4 46.5273 12.8898 34.3328 -6.46075 0.0352155 -21.0879 +3807 6 50.5846 18.7905 12.5321 0.161349 -2.47544 -10.5355 +3808 4 49.7474 18.3698 12.2516 10.3296 3.30344 0.704295 +3809 4 51.1853 18.7954 11.7538 -11.6392 0.795373 7.80699 +3810 6 32.4849 12.6316 31.9547 13.623 -32.1984 -17.1952 +3811 4 32.7548 11.6805 31.9646 -3.77817 17.5545 -6.43374 +3812 4 32.3724 12.7906 32.8759 -7.39939 11.2146 27.5789 +3813 6 6.21204 19.6856 10.0139 6.84548 18.8235 13.1049 +3814 4 6.54027 20.2383 9.28123 0.761161 -1.37122 2.72757 +3815 4 6.08461 20.3138 10.7689 1.69871 -13.3343 -16.4193 +3816 6 21.5267 21.5372 2.4283 -5.72751 11.2346 -5.82425 +3817 4 21.7624 21.5115 1.48057 4.80944 -6.6677 9.03128 +3818 4 21.9699 20.8013 2.88237 1.68469 2.19074 -10.3234 +3819 6 38.389 23.0803 17.19 -15.8009 11.2489 14.8144 +3820 4 38.843 23.3405 16.3672 7.30113 -17.2523 7.40945 +3821 4 38.5581 22.1678 17.4979 8.57434 6.38113 -15.3203 +3822 6 29.7009 24.9705 22.2505 40.9979 -45.9373 -29.6811 +3823 4 30.2007 24.9541 23.0531 3.51493 7.58579 28.6285 +3824 4 28.9709 25.5198 22.3387 -45.941 40.092 17.1582 +3825 6 30.3026 21.4444 37.7784 -57.0222 17.1687 -23.3742 +3826 4 30.3615 21.3347 36.805 9.38026 -2.23221 21.4717 +3827 4 29.3011 21.6413 37.9016 49.3444 -12.8915 1.59191 +3828 6 11.8723 11.7062 16.3108 -33.4349 -15.0686 -41.1118 +3829 4 11.3207 12.2631 16.8681 -3.98396 2.02201 -1.40695 +3830 4 11.3108 11.5232 15.4705 24.8968 9.48818 41.0096 +3831 6 5.70652 16.9717 10.4705 4.17204 -12.2255 5.26049 +3832 4 4.89872 17.0293 11.0039 1.44556 1.21447 -8.81597 +3833 4 5.85075 17.8293 10.0626 -3.65007 4.58518 2.58079 +3834 6 41.6977 34.1692 35.8837 -2.16171 7.35997 35.3278 +3835 4 41.9434 35.0359 36.2767 -7.39108 -12.3774 -11.2945 +3836 4 41.6554 34.2509 34.9408 0.248654 6.88642 -24.6778 +3837 6 33.755 1.15956 30.1148 26.9661 -5.30311 0.785489 +3838 4 32.8327 1.41064 30.2749 5.35845 -2.81639 19.5818 +3839 4 34.3082 0.981132 30.9387 -30.8845 7.54253 -18.2089 +3840 6 50.3537 18.6141 36.9811 22.0078 18.2711 -1.17075 +3841 4 50.0553 18.9081 37.8421 -3.0234 4.11827 7.26126 +3842 4 49.7241 17.9789 36.6994 -26.7065 -28.1871 -12.5747 +3843 6 24.6713 24.2747 40.2422 -22.5478 13.5437 8.83718 +3844 4 23.7682 24.4281 40.6159 16.469 -5.34198 -8.29501 +3845 4 24.8078 23.3187 40.2616 -1.76472 2.5507 -0.358513 +3846 6 37.3089 22.0315 23.2412 -5.67505 16.6134 8.34505 +3847 4 36.9227 21.8066 24.1113 8.4343 -8.15598 -10.5545 +3848 4 37.8295 21.3076 22.8826 1.63944 -5.88141 4.04288 +3849 6 48.4175 40.505 28.9613 -8.44239 17.3351 -31.8351 +3850 4 48.9168 41.2502 28.5701 -3.67522 -6.90368 3.5913 +3851 4 47.6498 40.4225 28.3398 9.75729 -4.39015 14.633 +3852 6 24.8456 8.73476 16.5822 -4.20971 0.107082 12.7896 +3853 4 25.4166 9.33437 17.0882 0.801486 -3.84637 -6.6671 +3854 4 25.3552 7.93888 16.3774 1.47583 -1.66023 -1.71228 +3855 6 19.2415 22.9983 32.4591 18.0731 -7.21062 -7.32059 +3856 4 18.4972 23.4837 32.0941 -3.55414 -1.2008 3.19393 +3857 4 18.9283 22.447 33.1757 -6.31405 0.951806 3.86493 +3858 6 3.33315 21.6719 22.4471 -31.3651 -15.1442 10.7623 +3859 4 2.72119 22.0562 23.134 20.4737 -7.45649 -18.1084 +3860 4 4.09369 22.238 22.38 14.9219 12.7334 2.89238 +3861 6 10.2287 20.327 12.827 -13.2346 -13.5387 -5.73443 +3862 4 9.59835 20.9044 13.2794 3.30523 -1.6991 -3.3419 +3863 4 9.66163 19.6709 12.3619 8.96671 11.3846 7.22783 +3864 6 9.52445 0.665703 25.3447 51.6699 36.9138 -22.1471 +3865 4 10.407 0.70007 25.8038 -28.3091 -11.588 2.11711 +3866 4 9.73816 1.30323 24.5834 -23.5062 -26.9191 23.3279 +3867 6 10.6629 40.7098 9.64162 -13.7092 -10.0604 -17.7529 +3868 4 10.6663 41.3337 10.3633 -2.25222 9.44489 9.13119 +3869 4 9.9177 40.9644 9.04966 14.1089 -1.91013 12.7496 +3870 6 46.3583 25.2138 32.6818 -7.00173 28.401 24.5039 +3871 4 46.1658 26.0815 33.1748 9.63216 -40.3762 -24.4036 +3872 4 46.6683 25.4845 31.8081 -0.340565 -0.626762 -0.366217 +3873 6 38.9398 3.19835 23.1062 35.7507 -3.98021 4.80576 +3874 4 38.0789 3.42388 22.7807 -21.691 0.0477325 0.592254 +3875 4 38.9606 2.6551 23.9199 -14.9585 3.95725 -7.0779 +3876 6 33.3518 23.6324 36.8776 -10.909 11.1506 22.2396 +3877 4 32.7475 23.7189 37.6717 16.9933 -10.7727 -23.1962 +3878 4 33.5054 24.5617 36.6454 5.48307 -3.56245 -8.14833 +3879 6 51.9403 33.327 25.4307 18.0164 46.0043 -41.5452 +3880 4 51.481 33.1217 26.2288 -14.6019 -1.8433 25.1586 +3881 4 51.8744 34.3335 25.2555 2.07578 -44.1738 12.4077 +3882 6 32.1773 25.016 33.1611 -3.65323 12.5958 -4.40686 +3883 4 32.7417 25.8243 33.1248 -13.2213 -13.5953 2.20315 +3884 4 31.2567 25.3353 32.9959 15.6883 -4.24783 1.324 +3885 6 51.2804 27.7082 39.5058 -12.4055 -13.8576 13.4454 +3886 4 51.6333 27.8214 38.6405 7.56348 -1.28822 -27.9214 +3887 4 51.668 28.4332 39.9759 4.38661 13.1583 16.7532 +3888 6 34.2776 28.325 17.2612 18.5433 -9.6807 0.726105 +3889 4 33.4618 28.7621 17.0499 -21.6526 10.7978 2.5619 +3890 4 34.2928 28.1986 18.2187 -4.64072 -2.98555 4.57564 +3891 6 36.914 8.0422 37.8636 -11.4128 -16.3489 28.1347 +3892 4 37.1972 8.46051 37.0352 12.2245 9.0272 12.2411 +3893 4 37.2151 8.41454 38.7513 -7.64029 -1.69915 -40.4466 +3894 6 34.8876 19.4054 6.12727 15.6033 7.52257 2.15709 +3895 4 34.0531 18.9355 6.15655 -6.74313 -1.04378 -1.75599 +3896 4 34.6977 20.3552 6.00766 0.606543 -4.24654 -1.2187 +3897 6 52.9513 9.46866 7.83406 2.51792 52.5995 -46.1577 +3898 4 52.8182 10.1965 7.1313 21.8169 -33.4663 26.408 +3899 4 52.1097 9.49548 8.25498 -20.9439 -11.3984 23.93 +3900 6 36.2784 5.48477 38.9735 -18.6298 -4.41122 2.56352 +3901 4 36.9459 5.47799 39.6359 15.3203 -14.8264 18.8091 +3902 4 36.5882 6.23606 38.5023 -2.18903 24.2959 -30.3279 +3903 6 10.0091 14.4595 13.4727 4.14065 20.8003 14.1725 +3904 4 10.1735 15.3719 13.8184 -7.35802 -17.2864 -8.75733 +3905 4 9.20522 14.5177 12.9398 -1.57173 0.82324 -0.279823 +3906 6 17.2166 24.3595 39.7866 10.3316 -24.6644 9.74438 +3907 4 16.8461 25.2181 39.6219 -11.8102 15.8188 2.99696 +3908 4 16.9967 24.0978 40.7081 2.51259 6.67153 -9.86646 +3909 6 49.0842 32.5535 7.76087 3.66191 -12.3496 8.85055 +3910 4 48.2705 33.0417 7.89853 -4.87459 2.09702 3.01394 +3911 4 49.5463 32.9698 7.04629 8.35168 7.01386 -14.6239 +3912 6 44.8849 24.3899 5.46806 25.9844 8.68062 13.8603 +3913 4 44.662 24.5947 6.37974 6.74107 7.22813 10.7323 +3914 4 44.0754 24.0079 5.20592 -32.7636 -20.0017 -25.3594 +3915 6 37.3054 29.188 32.8461 11.1431 -5.59449 16.1726 +3916 4 36.8523 29.4202 33.6742 6.83247 1.44061 -4.51415 +3917 4 36.6742 29.3068 32.1579 -22.7291 3.94299 -14.9304 +3918 6 0.907991 24.8221 21.2346 15.0832 19.7352 -4.57067 +3919 4 1.06453 25.2816 20.3717 -1.39622 -8.03116 21.3543 +3920 4 1.45755 25.2897 21.9154 -11.7661 -11.1398 -13.6241 +3921 6 53.0192 2.206 13.0014 -0.818186 11.5483 2.08343 +3922 4 52.7824 1.81345 13.8314 -6.90556 -15.4066 8.50991 +3923 4 53.4537 3.0128 13.31 2.83183 5.68595 -7.528 +3924 6 24.3052 33.9756 13.9324 20.4312 -11.5489 10.0229 +3925 4 23.7773 33.1726 14.1229 5.8111 10.1191 -2.33499 +3926 4 25.2169 33.8698 14.327 -30.0349 3.28274 -10.0023 +3927 6 40.9302 19.2912 0.318024 -15.3988 27.4065 1.86032 +3928 4 41.1581 18.3902 0.297675 9.36546 -44.4479 -0.119704 +3929 4 41.7646 19.7516 0.396104 7.20249 9.57203 1.55489 +3930 6 38.311 32.026 21.5914 -16.5672 24.1097 -12.7773 +3931 4 37.7777 31.3762 21.1012 4.07846 0.69211 1.97712 +3932 4 37.9765 32.9287 21.3171 8.34414 -28.994 10.9395 +3933 6 42.3062 34.9979 16.9676 -25.16 18.3345 5.87282 +3934 4 41.5364 35.0784 17.5803 19.0968 -0.611651 -8.13832 +3935 4 42.7061 34.1505 17.1117 7.13758 -14.417 1.0169 +3936 6 19.559 24.3289 21.9471 -10.3882 -39.985 28.3228 +3937 4 19.0651 23.5074 22.2416 22.0177 25.9498 -5.97634 +3938 4 18.911 24.732 21.3859 -10.0006 10.9377 -12.5795 +3939 6 21.0734 3.08215 14.9508 5.66735 1.93263 4.27485 +3940 4 21.953 3.50152 15.1067 -15.9394 -6.36392 -7.95302 +3941 4 20.9814 2.87634 14.0019 2.73511 2.88399 3.27523 +3942 6 16.4416 12.1461 28.5328 0.855962 3.79198 1.54672 +3943 4 16.9672 12.6551 29.168 -2.37031 -0.949071 -4.41291 +3944 4 15.802 12.7688 28.1665 0.405815 -3.95107 1.98596 +3945 6 29.5641 4.71626 21.7415 17.492 -20.3905 -14.0863 +3946 4 29.717 3.79719 21.4198 0.937107 17.7735 8.56359 +3947 4 28.6765 4.939 21.4721 -9.06619 5.19467 -0.439365 +3948 6 47.4133 12.088 13.4013 -19.6032 -12.6622 16.1152 +3949 4 46.7677 12.2286 12.6843 7.8139 0.82382 7.69043 +3950 4 46.8958 11.6888 14.1608 19.5987 16.3505 -27.3211 +3951 6 26.4348 0.0314913 5.59163 -38.6673 11.9556 1.59378 +3952 4 25.5144 0.513751 5.59151 44.3701 -31.5426 2.21012 +3953 4 26.2832 40.9933 5.84663 -4.6239 23.4679 -5.56234 +3954 6 20.8211 34.8097 41.3598 6.97593 19.5597 16.9804 +3955 4 20.8796 35.753 41.6458 -3.00787 -20.9192 -8.75426 +3956 4 21.5767 34.358 41.784 -4.89338 4.10004 -2.4608 +3957 6 12.6876 17.479 1.38718 -1.79098 16.5747 12.6529 +3958 4 12.721 17.2085 2.3151 1.79447 -6.15344 -4.56661 +3959 4 12.6249 16.7029 0.834077 -0.882684 -12.7315 -6.97767 +3960 6 30.0809 10.1879 8.41184 2.17826 -2.71045 -21.4672 +3961 4 29.3744 10.7602 8.07412 2.70218 -2.7161 1.39802 +3962 4 29.921 10.0821 9.33998 -2.4398 0.0699553 19.6849 +3963 6 36.338 5.45526 23.9203 5.99313 10.0946 16.1749 +3964 4 36.1182 6.35936 23.6236 3.48165 -5.42435 1.21963 +3965 4 37.0503 5.55216 24.5976 -11.7354 -2.45534 -11.6386 +3966 6 34.0137 39.9398 19.5054 17.9066 -9.75089 21.0607 +3967 4 34.5988 39.5452 20.1731 -15.7075 -1.02338 -1.83906 +3968 4 34.6431 40.5289 19.082 -7.6391 9.5881 -14.1485 +3969 6 25.1112 29.0201 17.0007 35.0878 36.529 -22.1514 +3970 4 24.4917 28.3695 17.2244 -30.3786 -36.8419 16.5077 +3971 4 24.8604 29.2867 16.1023 2.15056 -2.21883 6.37313 +3972 6 28.5036 21.3308 6.52422 21.0338 -5.55128 30.7615 +3973 4 28.0688 21.6386 5.71574 5.06238 16.4658 -0.926129 +3974 4 28.989 22.0506 7.05137 -24.5794 -13.751 -30.0602 +3975 6 18.6637 26.1498 0.432001 -8.53447 25.4727 10.2843 +3976 4 18.1393 25.3713 0.533905 -9.92127 -26.6833 -5.54807 +3977 4 18.1707 26.7698 1.00478 10.6071 3.27379 -7.60185 +3978 6 10.9817 29.7047 15.4617 -41.5317 11.7513 13.4553 +3979 4 11.6879 29.3608 14.9846 35.2501 -21.9962 -32.1318 +3980 4 11.3889 29.9926 16.2601 5.02956 8.45945 23.8164 +3981 6 33.4827 3.76017 10.5773 -2.41261 -0.304069 24.838 +3982 4 33.4731 3.39919 11.5182 2.46452 11.5285 -31.0446 +3983 4 33.5847 4.73535 10.6555 -0.240223 -15.9168 2.16837 +3984 6 12.2973 28.805 23.0387 -1.70787 -5.55619 5.61474 +3985 4 12.73 29.6571 22.9381 2.67417 5.94729 -0.690524 +3986 4 11.5024 28.994 23.5653 2.03311 -0.198261 -3.05575 +3987 6 13.0915 10.291 41.0216 -35.9662 5.53295 8.52282 +3988 4 13.8386 10.0408 41.5246 29.6538 -8.48465 17.7322 +3989 4 13.4107 10.5366 40.1733 8.17866 7.18603 -23.992 +3990 6 45.8162 29.981 22.3537 -23.4909 -34.782 -9.94688 +3991 4 46.3605 30.6906 22.6479 19.8522 18.211 11.3118 +3992 4 46.1638 29.1315 22.7274 -3.04842 19.9099 -5.39144 +3993 6 41.5671 12.1372 14.78 12.0724 6.03101 -10.0784 +3994 4 40.8481 12.1001 15.4119 -11.2612 -2.38036 6.73971 +3995 4 41.9114 13.0311 14.8874 5.93112 4.19505 -0.667369 +3996 6 18.1729 7.20363 24.1739 -28.0382 48.7978 3.52623 +3997 4 17.4064 7.85498 24.128 33.406 -18.9268 -1.93395 +3998 4 17.7199 6.38321 24.1568 -14.2968 -40.16 -0.285645 +3999 6 1.47767 28.308 7.57167 -25.5616 27.2209 -25.1393 +4000 4 0.827452 27.622 7.68711 2.49251 -16.9659 6.86802 +4001 4 0.906232 29.0217 7.18328 24.331 -5.18373 6.93061 +4002 6 11.3359 12.3164 24.0718 -23.8013 37.4997 -14.7667 +4003 4 11.6691 13.0224 24.6595 3.51665 -15.1291 3.43827 +4004 4 11.6925 11.4858 24.3227 20.8697 -21.176 20.4973 +4005 6 17.9852 40.4684 24.4198 -2.05389 -13.7174 33.2687 +4006 4 18.291 40.9889 23.6947 8.79563 24.1615 -11.819 +4007 4 17.8495 41.0209 25.2243 7.13458 -7.65509 -20.9696 +4008 6 25.5964 7.43792 34.0141 13.5012 12.0052 -20.5927 +4009 4 25.8913 7.969 33.2287 -3.90825 -14.1502 17.4414 +4010 4 24.6674 7.63663 34.1466 -9.57807 0.741149 3.27376 +4011 6 16.9692 36.3856 7.79034 -41.9934 -28.8773 9.66508 +4012 4 16.1027 35.9203 7.98218 37.4859 8.56847 -14.648 +4013 4 16.8197 37.2026 8.24874 12.7807 20.325 5.07796 +4014 6 12.4125 39.1679 36.8113 4.83627 -30.6012 -9.1357 +4015 4 13.2866 39.4994 36.9682 3.20673 22.8904 8.84646 +4016 4 12.7018 38.3069 36.4569 -23.4958 5.90479 1.90955 +4017 6 23.4443 1.91649 37.7131 1.30421 0.985484 -2.89526 +4018 4 22.7028 1.66545 37.1374 7.60384 11.2995 4.79583 +4019 4 23.7753 2.79308 37.4363 -6.35903 -5.24233 -3.11404 +4020 6 26.6169 34.8556 39.068 -18.8945 24.0174 -16.1573 +4021 4 25.9011 35.0209 39.7003 9.00825 -5.11239 -0.809586 +4022 4 26.448 35.531 38.356 7.64302 -20.2436 14.8851 +4023 6 44.7566 35.572 23.174 8.53117 -4.94531 -21.3447 +4024 4 44.5551 36.3183 23.7275 -7.66893 11.3086 12.1688 +4025 4 44.9082 35.9286 22.2729 -0.906387 -11.1819 10.3159 +4026 6 34.6091 35.4265 26.6991 -7.96701 8.74937 -1.29134 +4027 4 33.7558 35.2865 27.1578 16.0802 3.93421 -4.37465 +4028 4 35.2785 35.5457 27.4013 -9.86041 -2.80018 -4.60569 +4029 6 12.4308 29.8402 9.37325 4.00701 15.5633 13.1387 +4030 4 12.6298 30.2095 10.2592 0.427445 -8.8693 -11.9579 +4031 4 11.9163 30.5385 8.94302 -0.259504 -4.09781 -0.505047 +4032 6 46.4536 41.3715 16.9585 -0.509472 -10.7221 -3.48983 +4033 4 46.3968 0.20327 17.5639 0.209317 7.43894 6.10767 +4034 4 46.3711 41.769 16.0793 0.075994 -2.20044 0.741492 +4035 6 39.1811 31.047 24.0166 -28.3946 14.7902 -31.7872 +4036 4 39.0009 31.2944 23.0615 15.0891 -8.50563 28.3067 +4037 4 38.282 31.1199 24.3765 13.6746 -2.33731 7.34059 +4038 6 40.5375 9.75603 28.9763 9.47615 -22.8392 -16.3574 +4039 4 40.717 8.78834 28.9749 -4.02124 18.0325 0.597023 +4040 4 40.0442 9.94417 29.7674 -4.45736 4.50836 13.2228 +4041 6 33.5752 11.9033 22.735 -22.7947 23.9621 15.9921 +4042 4 33.2963 12.1808 21.8555 7.18969 -8.33444 -8.87292 +4043 4 33.0376 12.5465 23.2695 22.9257 -24.0379 -3.52442 +4044 6 29.0301 38.739 2.44557 13.7604 -11.9544 -20.6568 +4045 4 29.2066 39.6607 2.23242 1.09325 2.62923 1.14408 +4046 4 28.4566 38.7797 3.20164 -8.68487 1.4276 10.4377 +4047 6 51.2789 6.14828 28.303 0.614736 -0.570337 1.8431 +4048 4 51.6973 5.27456 28.1665 -1.53436 11.093 -0.261734 +4049 4 51.6265 6.73477 27.6091 2.17001 -12.1019 4.10374 +4050 6 34.1129 16.6124 14.0322 -32.0491 -20.8609 -4.49638 +4051 4 33.8537 17.5241 13.9801 -4.99199 17.3104 -1.82528 +4052 4 35.0495 16.5739 14.0336 36.3732 5.94549 -0.19423 +4053 6 34.4398 40.0505 7.51971 -1.5967 1.86622 -34.5907 +4054 4 34.4907 40.736 6.82898 6.47702 11.7366 29.0204 +4055 4 34.1466 39.3906 6.89306 -3.09667 -23.6565 15.965 +4056 6 42.5416 22.9885 4.36731 16.709 1.02816 -9.65968 +4057 4 42.6773 23.0677 3.40021 -12.3994 2.37358 9.8727 +4058 4 41.6332 23.2481 4.59133 5.34809 1.54884 -5.45539 +4059 6 1.43335 11.7249 10.5915 17.9648 34.7983 -1.93775 +4060 4 2.18855 11.6351 9.93392 -25.2532 9.63542 18.7746 +4061 4 1.3761 12.7012 10.8984 13.7257 -41.7135 -20.7702 +4062 6 10.0197 17.1509 40.4023 -3.34945 -21.541 12.0793 +4063 4 9.07741 16.8499 40.449 26.596 5.40866 2.75879 +4064 4 10.6028 16.482 40.874 -24.6204 18.7768 -14.392 +4065 6 26.3793 1.16939 23.7984 9.5834 26.112 -20.0106 +4066 4 26.3482 1.63114 22.915 -1.08564 -15.7005 23.7132 +4067 4 26.8817 1.81632 24.3342 -3.35925 -10.5223 -0.68284 +4068 6 4.47487 16.2271 39.0058 33.4959 -10.553 -10.6989 +4069 4 4.63618 15.8937 38.0801 -2.33968 7.70086 24.4633 +4070 4 5.35244 16.1813 39.5129 -32.5033 1.65679 -19.7071 +4071 6 24.3835 39.8482 14.0852 2.84697 7.18038 -0.286146 +4072 4 24.1877 40.6985 13.6429 5.77715 -11.144 2.19115 +4073 4 25.1234 39.4426 13.6288 0.754333 1.29636 -3.16103 +4074 6 19.9701 19.0136 10.1131 -5.22385 -12.8057 23.8822 +4075 4 19.1001 19.3633 10.3498 -0.643873 5.13605 -7.14836 +4076 4 20.1315 18.3631 10.8504 3.64009 16.176 -24.2707 +4077 6 45.2329 15.0638 25.3099 -19.5547 20.2245 12.2671 +4078 4 44.4482 15.622 25.4263 4.62838 7.04728 2.57625 +4079 4 44.8851 14.3824 24.752 0.155489 -22.5403 -14.0061 +4080 6 47.6439 32.9533 29.9771 4.38746 -1.69347 6.40492 +4081 4 47.8622 32.5347 30.8309 -5.05982 6.77924 -7.14273 +4082 4 46.6855 33.0215 29.8843 -3.06966 -4.44082 4.14054 +4083 6 9.30872 14.1631 35.6268 19.7088 14.7601 29.7215 +4084 4 10.221 13.8687 35.4779 -5.99131 -8.3331 -9.89462 +4085 4 9.36538 14.5282 36.5395 -10.4264 -5.45721 -18.9107 +4086 6 0.534978 28.7509 32.1461 -15.0727 14.1973 -4.1115 +4087 4 0.468283 29.1163 31.2513 -2.72678 6.96628 5.64212 +4088 4 0.834469 27.866 31.9601 7.81775 -11.1437 7.49829 +4089 6 26.1375 14.1816 40.8286 20.1166 -40.7048 30.4826 +4090 4 26.3241 13.5573 41.5993 3.0023 20.8863 -27.3959 +4091 4 25.2151 14.3343 40.9319 -22.5068 13.4131 -3.44564 +4092 6 38.0468 1.72227 37.358 -19.6589 11.4537 -4.22791 +4093 4 38.2764 1.77906 36.4154 -1.14244 -2.14966 7.97792 +4094 4 37.182 2.20858 37.4052 20.9639 -13.8426 2.93072 +4095 6 43.3928 21.0193 0.385094 -33.4221 -4.11839 13.5226 +4096 4 43.2305 21.8771 0.864972 20.5484 -13.2955 -16.2126 +4097 4 44.243 20.9573 41.8451 7.78799 18.4844 3.58779 +4098 6 29.7343 12.3918 17.0888 -10.4088 14.6249 -44.7733 +4099 4 30.3573 13.1084 17.3121 -1.69191 -12.5137 15.8564 +4100 4 29.5365 11.7717 17.7855 9.28071 1.18848 24.195 +4101 6 21.0845 11.002 35.643 19.2467 11.9534 29.728 +4102 4 20.8387 11.9292 35.5336 -5.23529 -0.657509 -1.91086 +4103 4 20.6782 10.509 34.9529 -15.7216 -13.7754 -25.5995 +4104 6 24.3584 22.1274 17.054 -19.116 4.6391 -13.6617 +4105 4 24.8062 22.8618 16.6504 0.246813 15.5697 -7.02352 +4106 4 25.0581 21.6899 17.4914 19.3443 -19.237 19.9016 +4107 6 44.2632 9.62803 6.15095 12.4515 -7.11379 4.41615 +4108 4 44.6939 9.46248 5.31272 4.1824 -3.3463 -6.13814 +4109 4 43.3875 9.94101 5.94426 -13.441 6.05535 2.74078 +4110 6 40.7983 2.89203 6.29118 6.30341 -5.06299 2.94692 +4111 4 40.283 3.08384 7.0886 -2.93464 8.08246 -11.2803 +4112 4 40.6425 3.53992 5.58152 -5.48248 3.30556 7.46891 +4113 6 23.4927 29.787 25.2074 -17.9847 -14.6764 23.1638 +4114 4 22.9663 29.9524 24.4255 0.505661 2.84572 -7.25135 +4115 4 24.3189 30.243 25.1366 19.4862 15.0746 -12.06 +4116 6 45.2253 20.6067 7.48804 -4.5495 -5.9569 -0.737791 +4117 4 44.4771 20.6075 6.85512 7.98227 -4.73543 5.3389 +4118 4 45.4897 19.6858 7.65762 -3.7219 7.49041 -4.48952 +4119 6 44.1869 26.5802 16.6604 -2.53584 -23.4697 22.3036 +4120 4 44.4278 26.4187 15.7655 11.491 9.41288 -34.0672 +4121 4 43.9629 25.6676 16.9 -3.51956 3.82806 13.7521 +4122 6 23.5847 27.0608 18.0875 4.92857 -1.63386 -8.1099 +4123 4 23.1417 26.2886 17.6568 -1.85204 16.5134 12.3838 +4124 4 22.9956 27.5067 18.7318 1.2523 -15.787 -12.8337 +4125 6 45.1423 16.1006 8.91925 -12.5826 4.07054 -12.5551 +4126 4 44.1756 16.0018 8.7625 13.8686 2.25455 7.61002 +4127 4 45.2849 15.9649 9.86163 -1.87368 -3.25302 7.37304 +4128 6 39.0195 15.168 5.20911 22.9796 -5.95468 -13.3261 +4129 4 39.8169 15.5451 4.76197 -16.8333 -0.501818 4.44847 +4130 4 38.2997 15.7872 5.12886 -6.79784 14.0419 -3.1922 +4131 6 40.4728 4.77172 20.098 -25.5728 -7.96759 5.38455 +4132 4 41.2852 4.73631 19.62 25.1414 0.345713 -9.53623 +4133 4 40.6586 5.20983 20.9254 2.90807 4.2574 9.49937 +4134 6 35.8334 28.4358 39.8978 -29.6544 -30.7382 0.627816 +4135 4 35.064 27.7738 39.8775 30.8234 30.4338 1.60118 +4136 4 36.4992 28.0138 39.3349 2.0747 -0.608826 -0.916217 +4137 6 26.5626 3.56604 2.67563 -12.8067 -1.70274 -2.52813 +4138 4 26.0244 3.493 1.8476 6.72613 8.7381 24.6483 +4139 4 26.0719 4.09981 3.36162 5.66066 -13.1585 -23.5937 +4140 6 2.95645 21.6514 17.6824 -3.82104 6.40043 0.291571 +4141 4 2.91294 22.1823 18.4797 -6.37673 0.600795 10.7096 +4142 4 3.68258 22.033 17.1814 1.62588 2.51689 -6.09233 +4143 6 12.886 25.0591 25.9256 19.9254 19.7817 -8.37483 +4144 4 13.3104 25.904 25.618 -13.2675 -16.998 3.60223 +4145 4 12.0452 24.9678 25.4656 -4.65807 1.85418 -5.64346 +4146 6 41.5793 20.6554 14.1751 9.92193 3.46069 0.25892 +4147 4 42.3122 20.2044 13.7523 0.767115 -12.7084 -7.64783 +4148 4 41.9959 21.4893 14.4245 -8.84771 2.34114 1.73285 +4149 6 1.24495 39.6039 11.5378 16.0363 -42.6363 3.17437 +4150 4 1.64626 38.7705 11.134 -18.3255 36.4754 4.46196 +4151 4 1.41802 39.4632 12.4909 -5.9615 12.3362 -8.98123 +4152 6 16.0218 39.0109 34.0619 -0.331369 12.6721 -5.4452 +4153 4 15.5475 38.1996 33.7806 5.75571 19.7523 -4.5346 +4154 4 15.9899 39.7855 33.4251 -7.29137 -28.599 9.21448 +4155 6 20.567 7.02475 25.5588 2.3848 7.82756 -0.6535 +4156 4 20.909 7.86076 25.1782 -7.45606 -9.2474 3.61042 +4157 4 19.6275 6.99553 25.3185 5.42042 5.25175 -3.5088 +4158 6 45.1928 25.5902 39.1787 -21.925 2.17874 18.9559 +4159 4 45.8631 26.0435 38.6892 20.8233 13.1115 -15.3132 +4160 4 45.3324 24.6675 39.0115 4.42968 -17.7425 -2.36405 +4161 6 19.9342 40.1138 28.2835 12.5964 -14.0671 -7.25792 +4162 4 19.0067 40.1593 28.0096 1.46425 5.68018 7.52545 +4163 4 20.128 40.8224 28.917 -7.48392 0.334406 -3.99949 +4164 6 26.4878 14.2069 27.3684 6.98603 -7.23951 -28.1548 +4165 4 25.5412 14.1932 27.2537 -20.7302 0.754551 -2.34698 +4166 4 26.606 14.4537 28.2745 0.836708 4.29804 26.5652 +4167 6 51.3489 25.9487 3.45136 10.7849 20.7191 -13.686 +4168 4 51.0453 25.2386 4.01334 -1.8549 -15.8565 1.21982 +4169 4 51.853 25.5737 2.69356 -6.32678 0.0553236 13.0587 +4170 6 20.1633 26.1247 2.67289 8.83438 -16.1267 5.68002 +4171 4 20.5345 25.2411 2.88723 -1.43181 13.9101 -1.64203 +4172 4 19.9438 26.1088 1.72974 -0.778515 0.427063 3.21599 +4173 6 3.13549 11.9681 27.2232 16.3616 22.3682 9.86323 +4174 4 2.68005 12.663 26.7181 4.92926 -3.58697 -0.471129 +4175 4 3.70389 12.4466 27.8862 -15.0224 -10.9098 -14.9284 +4176 6 30.1793 26.3687 4.00051 28.7119 -30.2966 58.1206 +4177 4 30.7801 25.8341 3.46925 -1.584 2.83444 -17.1702 +4178 4 29.6371 26.9341 3.51662 -25.563 30.6813 -37.7958 +4179 6 19.3205 20.6733 30.5441 -31.721 -6.25106 8.6959 +4180 4 19.1895 21.5008 31.0287 11.509 1.10551 -1.6952 +4181 4 20.2026 20.5869 30.2 22.6938 9.52703 -0.947482 +4182 6 13.5381 36.2475 0.344803 0.685356 24.2985 -17.2657 +4183 4 13.9232 37.1122 0.0997808 14.0363 -10.2996 17.9143 +4184 4 12.867 36.2368 41.5779 -17.3214 -19.7281 -1.62589 +4185 6 13.6931 21.7661 35.9637 -11.3229 -11.9655 -19.5688 +4186 4 13.4645 21.416 35.0694 1.68887 6.71419 14.5774 +4187 4 14.5559 22.1488 35.8465 12.3178 6.48213 0.887249 +4188 6 39.4176 1.76287 25.342 34.0854 -16.9064 9.57103 +4189 4 40.0026 2.33061 25.8435 -14.6367 28.4588 7.32056 +4190 4 40.0689 1.04185 25.2643 -19.5027 -7.65211 -10.5764 +4191 6 18.2964 6.13492 35.8264 -1.82227 -5.92686 -23.3299 +4192 4 18.1639 5.26767 36.254 2.04199 12.8657 6.45456 +4193 4 18.4232 6.85005 36.4651 0.375802 -9.94466 7.47089 +4194 6 2.53148 24.639 10.0969 -49.4669 34.6161 -0.50772 +4195 4 3.3243 24.1433 10.0889 43.7683 -7.59463 9.24933 +4196 4 2.65209 25.5465 10.4987 14.0059 -27.2835 -7.72375 +4197 6 35.8204 9.94567 1.34298 17.6587 14.9905 11.506 +4198 4 36.311 10.4135 0.64327 -4.10869 -3.12473 7.53129 +4199 4 36.1923 10.315 2.19711 -13.0886 -16.0695 -26.9686 +4200 6 29.0171 17.933 41.5847 -7.4648 10.4738 41.1296 +4201 4 28.4325 17.2741 41.1888 4.90819 -0.226834 -17.309 +4202 4 29.634 18.3354 40.9804 6.59061 1.40283 -25.0927 +4203 6 46.0097 27.0807 25.8707 -17.7195 2.90801 -6.40423 +4204 4 46.7639 26.9189 26.4445 5.86789 -6.79057 7.62258 +4205 4 45.3727 26.3443 25.9794 8.73043 2.74283 1.98831 +4206 6 28.1087 10.6569 35.9055 -15.3417 -26.5964 -30.9314 +4207 4 27.3182 11.0018 35.4375 11.5227 2.30745 10.116 +4208 4 28.4572 11.2922 36.5111 4.26863 23.9808 15.1461 +4209 6 25.95 20.1976 24.7821 3.31321 9.63686 -4.79579 +4210 4 26.7637 20.7132 24.6155 -9.40037 -7.04512 10.7501 +4211 4 25.7749 20.1865 25.7378 6.19451 4.49283 1.81458 +4212 6 32.2481 30.2487 10.2005 -0.567171 -33.888 25.4585 +4213 4 32.5217 30.8918 9.54162 14.407 -2.03846 -6.18424 +4214 4 32.9483 29.5597 10.4163 -8.30199 27.6945 -16.8968 +4215 6 5.04696 34.3919 23.8165 18.9071 9.10073 -2.65681 +4216 4 5.8517 34.9395 23.7378 -5.43375 -12.4066 7.00495 +4217 4 4.47737 34.8578 23.2154 -15.6684 -1.23826 -5.97721 +4218 6 29.6446 34.9396 23.1073 8.37026 13.2143 1.46186 +4219 4 30.146 35.227 23.8877 -4.79805 -2.96005 -2.8646 +4220 4 29.6355 33.9874 23.1398 -0.169507 -13.2925 4.62646 +4221 6 52.2021 25.2197 36.2484 0.203165 -13.9358 18.8619 +4222 4 51.9199 25.3821 37.1814 5.20177 -0.668093 -22.6011 +4223 4 52.2823 24.2449 36.2046 0.468647 8.20491 -0.432122 +4224 6 6.9564 41.2598 14.9786 17.963 -12.3423 -19.5336 +4225 4 7.05881 41.0384 15.8913 -5.14113 -1.34859 16.0369 +4226 4 7.66895 40.7276 14.5577 -14.5347 12.9973 2.09466 +4227 6 27.6566 39.1405 4.67566 -15.1179 -12.1251 22.0677 +4228 4 26.8424 38.6352 4.89635 10.0979 9.09612 -9.05456 +4229 4 28.2356 39.0161 5.44259 -0.0995191 -2.46215 -4.35417 +4230 6 44.4488 15.8848 30.3925 -17.4686 4.63448 -32.2897 +4231 4 43.6243 16.41 30.3099 13.0937 -10.0294 9.08699 +4232 4 44.649 15.6212 29.457 1.77951 4.94888 23.2191 +4233 6 27.3024 38.1054 13.0907 0.224949 -17.5042 -4.12929 +4234 4 27.6483 37.328 12.5833 -5.61487 10.2238 13.6353 +4235 4 27.1416 37.8221 14.0243 3.20236 0.189733 -16.1751 +4236 6 26.6663 32.9851 36.8362 -23.8807 -10.2072 10.655 +4237 4 27.4028 33.4987 36.5569 24.2269 11.6336 -10.1628 +4238 4 26.2735 33.5165 37.5295 -1.35435 2.25064 8.62378 +4239 6 26.3226 28.1988 31.7158 32.4613 11.5871 5.04411 +4240 4 26.7492 28.3346 30.8217 -6.54697 -0.873531 32.5908 +4241 4 26.9302 28.5068 32.4691 -17.7353 -8.90623 -33.5497 +4242 6 49.2114 35.7792 23.3295 1.46842 19.8344 9.76806 +4243 4 49.8184 36.2235 23.9243 -3.28067 3.63886 4.6357 +4244 4 49.746 35.0988 22.9506 10.5329 -22.9043 -16.5919 +4245 6 44.2369 15.3613 33.5367 -0.695853 -9.37614 14.4104 +4246 4 44.9539 15.1613 32.9326 3.59625 1.2978 -8.28609 +4247 4 43.6189 15.9562 33.0977 0.720121 5.36694 -8.04858 +4248 6 16.6517 35.2697 14.032 -14.9609 -5.91625 -15.8105 +4249 4 16.8478 36.086 14.4923 5.97715 10.4369 8.21626 +4250 4 15.7311 35.3947 13.7134 15.021 -1.16653 5.16189 +4251 6 45.2991 21.4701 12.0564 -47.5016 11.1637 19.3857 +4252 4 45.9844 21.105 11.5386 20.9258 -26.0087 -22.2564 +4253 4 44.5936 20.7913 12.2178 25.8967 12.3347 -6.55717 +4254 6 51.6438 5.33792 20.1099 7.42219 12.4384 36.9688 +4255 4 51.7517 5.79258 20.9932 -2.42789 -17.2577 -23.3969 +4256 4 50.9203 5.81642 19.7 -6.55397 4.36408 -6.3714 +4257 6 22.6153 27.305 0.955308 -12.5158 1.22245 6.52354 +4258 4 21.8819 27.8542 1.31405 9.62632 -7.19502 -8.89748 +4259 4 23.0385 27.8458 0.276527 0.370713 4.24399 -0.0338259 +4260 6 46.8868 12.1467 22.3289 10.3551 9.03073 -1.70047 +4261 4 46.473 12.5446 21.5671 -2.12653 7.07083 -14.4911 +4262 4 46.1639 11.6922 22.7348 -15.0603 -15.1984 17.3736 +4263 6 33.7555 5.60359 25.2366 8.41588 -11.9289 0.48427 +4264 4 34.4013 5.10188 24.7086 -2.4022 4.68399 3.96997 +4265 4 33.0757 5.86414 24.6127 -5.93503 4.46215 -0.558809 +4266 6 44.2476 18.1243 27.2334 30.0322 17.9475 -5.65933 +4267 4 44.0927 18.7931 26.5253 0.465456 -9.97561 17.2792 +4268 4 45.207 18.2464 27.4768 -29.0014 -6.50023 -5.41996 +4269 6 5.27814 37.006 29.0846 -42.995 37.8911 -11.235 +4270 4 4.83357 37.8684 28.7516 22.264 -36.721 16.075 +4271 4 6.19253 37.2033 29.2507 20.6764 5.54169 3.86921 +4272 6 20.033 5.01392 38.9409 6.34377 -32.2179 -4.45843 +4273 4 19.8009 5.56625 39.6765 -4.47316 13.7366 14.9565 +4274 4 20.2948 4.14306 39.3359 -6.8578 18.535 -7.22498 +4275 6 17.9112 2.77214 33.8677 -16.6976 6.01838 23.4157 +4276 4 18.6113 3.34266 33.5322 6.18073 5.31505 -2.96417 +4277 4 17.3526 3.28629 34.5246 17.6921 -17.568 -20.3177 +4278 6 5.56788 23.3774 22.3326 -7.55986 13.5725 18.1102 +4279 4 6.25354 23.3408 21.6412 1.32241 8.57002 8.68476 +4280 4 5.72116 24.1623 22.9232 3.31135 -14.4794 -19.5174 +4281 6 12.7438 28.0244 40.0809 14.6998 26.4392 -25.8726 +4282 4 12.8099 29.0023 40.1455 -0.120572 -14.3051 2.54846 +4283 4 13.1526 27.8611 39.1965 -9.74214 -4.86635 20.6942 +4284 6 50.5283 38.8014 28.4207 -10.7676 14.1923 -1.71082 +4285 4 51.0354 39.5212 28.0559 20.7423 0.788408 -10.014 +4286 4 49.7626 39.3052 28.7255 -7.2831 -13.6434 5.52883 +4287 6 33.5501 8.21498 17.8605 -32.9279 -35.4008 39.405 +4288 4 33.9027 8.87262 17.3189 24.9798 40.0041 -36.6225 +4289 4 33.9074 7.37462 17.5752 8.43731 -7.27798 -4.46199 +4290 6 34.6457 34.7004 17.7764 -12.4293 -15.9601 -10.9704 +4291 4 35.1223 35.3606 18.2944 6.48769 -0.751965 0.253856 +4292 4 35.2388 33.9528 17.5616 -1.14344 9.31979 5.2604 +4293 6 40.7233 5.29016 23.4005 8.26322 -6.33781 10.3585 +4294 4 41.4774 4.87923 23.8731 -9.49225 7.91527 -13.3731 +4295 4 40.0307 4.6112 23.3711 2.34129 5.18948 -0.0201455 +4296 6 16.9127 27.7621 14.4682 52.6044 -4.68653 -2.89351 +4297 4 16.0711 28.1345 14.4444 -59.8378 16.6137 -1.60006 +4298 4 17.4608 28.5627 14.561 1.7801 -9.46587 0.070581 +4299 6 29.0363 14.6633 5.00698 9.76413 -9.29226 13.7719 +4300 4 29.5096 13.8001 4.93115 -9.10936 16.1071 1.03458 +4301 4 28.802 14.7746 5.95339 2.50956 -1.40994 -14.9204 +4302 6 36.8445 17.7203 5.07362 13.6951 -24.032 -28.6565 +4303 4 36.3003 18.4061 5.45056 -9.17068 14.5835 0.43155 +4304 4 36.9783 17.8862 4.10178 -4.81067 2.65881 25.6667 +4305 6 27.7152 25.5071 34.8558 20.6182 -10.3116 10.9196 +4306 4 28.4128 25.1948 35.4689 -8.51497 -1.72528 -14.7569 +4307 4 27.3626 26.2325 35.3632 -10.8781 12.0961 2.58089 +4308 6 24.7577 17.2803 18.064 -3.70908 -2.75228 5.17573 +4309 4 25.2464 17.9619 18.5343 4.21458 5.85634 1.04617 +4310 4 24.0216 17.073 18.6635 3.98676 -0.349172 -5.54229 +4311 6 30.1887 1.57939 5.82314 -15.3902 21.7461 -57.8894 +4312 4 29.5204 1.81013 6.46928 0.301846 -2.58557 7.21893 +4313 4 29.8355 2.03332 4.95505 20.4457 -28.7719 49.9963 +4314 6 37.4518 25.9014 8.44867 -40.4019 -33.5071 29.4213 +4315 4 38.3881 25.8301 8.67833 5.27698 -2.9507 2.74989 +4316 4 36.9261 25.2192 9.0364 31.48 35.4073 -33.2345 +4317 6 24.7717 7.01585 2.25321 22.1725 6.13312 -2.42992 +4318 4 25.3573 6.36243 2.67285 -8.4103 6.94319 2.38151 +4319 4 23.8861 6.6751 2.35128 -10.8992 -4.25211 1.65182 +4320 6 25.7992 38.8457 10.7505 7.22571 37.8744 -16.0906 +4321 4 26.2906 38.615 11.5103 14.31 -23.6918 34.358 +4322 4 26.1189 39.766 10.6411 -14.7913 -5.88601 -10.6141 +4323 6 0.557249 13.5851 28.1314 4.10373 25.7622 10.4527 +4324 4 0.335523 12.7734 27.7191 -4.86664 -22.4284 -15.6315 +4325 4 0.332586 13.4422 29.0593 -0.0574933 0.663208 0.855409 +4326 6 20.4027 17.1068 12.0342 -11.148 -26.8285 -23.5414 +4327 4 20.2541 17.2545 12.9674 -4.18463 -1.09026 14.619 +4328 4 19.9228 16.2663 11.7843 12.058 20.2306 8.20324 +4329 6 30.9875 7.38585 16.6706 43.1327 18.1844 -1.13431 +4330 4 31.2844 7.10043 15.7746 -9.95685 2.73348 15.1831 +4331 4 31.8198 7.8213 17.056 -34.7561 -19.1709 -8.28734 +4332 6 10.1956 5.78615 12.1691 19.1166 9.414 40.461 +4333 4 10.1305 6.30649 11.4071 -1.6074 30.0602 -42.5686 +4334 4 9.61456 5.08708 11.9844 -30.6818 -38.1141 -6.43609 +4335 6 18.4382 31.3444 24.1606 1.21336 -6.12525 2.83497 +4336 4 18.3965 30.3858 24.3134 -0.788465 1.61506 0.642095 +4337 4 18.2608 31.7571 25.0112 -0.825834 1.26386 0.0223154 +4338 6 27.8905 29.2615 29.2809 39.8074 15.5588 -29.008 +4339 4 28.4007 29.5348 28.4528 -32.3375 -5.53357 22.8869 +4340 4 28.6323 28.9656 29.8273 -8.8667 -4.73078 13.1255 +4341 6 38.3648 15.4483 29.7818 29.0993 -31.9427 29.9284 +4342 4 38.2401 14.49 30.0972 1.05022 38.774 -16.5136 +4343 4 39.2299 15.7257 30.2111 -34.0699 1.82394 -15.2271 +4344 6 21.7074 34.7851 5.58078 8.19375 -39.9271 5.99876 +4345 4 21.4944 33.8203 5.80476 0.548141 38.153 -5.97617 +4346 4 20.9458 35.3238 5.82701 -5.25279 -7.50871 2.73382 +4347 6 18.2117 16.8293 1.01571 -12.7233 9.06437 9.63769 +4348 4 17.5846 17.1799 0.363518 5.67247 -6.87112 -0.25098 +4349 4 17.8106 17.1001 1.86952 7.78128 -5.5379 -6.7416 +4350 6 43.5131 18.5098 39.3469 22.8992 -24.809 -24.744 +4351 4 42.9473 19.1501 39.756 -14.025 22.4758 -1.21679 +4352 4 43.733 18.7829 38.41 -14.2449 3.90475 27.8798 +4353 6 17.7973 10.0724 35.5497 11.3899 1.25644 -17.5776 +4354 4 17.9076 9.35875 36.1674 -1.9111 -9.85084 12.7139 +4355 4 18.4727 9.8826 34.8661 -11.1758 5.45367 7.50841 +4356 6 36.5836 30.5676 29.0795 -26.735 36.4018 -15.4516 +4357 4 36.5101 31.4618 28.6208 1.83791 -30.0083 14.6126 +4358 4 37.4767 30.2665 28.9506 20.8385 -5.81304 -4.31186 +4359 6 38.5024 35.9654 10.4302 15.5283 7.61871 55.4477 +4360 4 38.713 36.6589 11.1463 -7.3207 -22.805 -33.4203 +4361 4 38.3781 35.1576 10.9824 1.19538 10.4075 -12.7486 +4362 6 43.3976 18.7941 34.3717 -4.38817 -12.2014 30.3889 +4363 4 43.0627 18.1963 33.6763 0.988603 1.53223 14.3474 +4364 4 43.2603 18.4022 35.293 0.0857578 9.32555 -37.8245 +4365 6 11.0576 40.22 6.11206 -6.0837 -9.04747 -4.15047 +4366 4 11.6426 40.8981 6.46389 1.08734 7.77423 2.35531 +4367 4 10.1474 40.5638 6.06331 9.30243 4.06404 0.87098 +4368 6 48.3282 13.7431 24.4718 -8.87905 25.3224 16.0087 +4369 4 47.8536 13.4091 23.7195 -8.5266 -8.47545 -16.9724 +4370 4 47.8942 14.6072 24.6749 14.3726 -19.4181 -2.72093 +4371 6 1.47819 25.7805 23.7819 -0.0731812 -13.4431 -3.72387 +4372 4 0.822875 26.4404 23.4927 11.4147 5.84295 7.97453 +4373 4 2.19403 26.202 24.2849 -5.19934 9.21725 -1.17005 +4374 6 20.5754 0.0393205 21.1081 25.6075 5.05031 -17.3956 +4375 4 19.8484 0.361847 21.622 -17.4675 -5.38456 12.9096 +4376 4 20.5586 40.9849 21.0455 -11.1839 1.66381 7.6849 +4377 6 37.6642 12.8991 30.7037 -9.9457 -20.8438 -29.8221 +4378 4 37.1371 12.462 29.9889 18.2914 6.1257 8.16018 +4379 4 36.9745 13.1334 31.2979 -14.5618 11.4049 21.409 +4380 6 49.47 17.3794 9.25364 5.30826 8.19981 -9.14457 +4381 4 48.5231 17.6061 9.31556 15.6584 -1.48937 -5.70503 +4382 4 49.8852 17.9254 8.53549 -14.9109 -12.0851 17.4703 +4383 6 34.3662 5.35535 17.144 13.1974 2.57034 -29.0571 +4384 4 34.5198 5.2998 16.166 0.54303 4.43319 20.4174 +4385 4 33.4623 5.07036 17.243 -16.3394 -6.24992 8.38082 +4386 6 14.7833 27.6665 0.0728061 -6.74966 -7.64198 -7.69033 +4387 4 13.9925 27.8402 41.4242 12.1928 3.48747 9.75107 +4388 4 15.1668 28.5017 0.401621 -7.96817 -0.0208253 -5.02821 +4389 6 48.8656 15.5206 20.7458 -9.86138 0.136748 20.6241 +4390 4 49.0651 16.3952 20.4263 0.209458 6.72405 -7.85333 +4391 4 49.1204 14.8922 20.0789 6.79298 -9.16117 -16.8166 +4392 6 23.807 40.3882 20.3905 -3.398 23.5063 24.1729 +4393 4 23.5208 41.0259 21.1064 9.42377 -19.8715 -22.5683 +4394 4 24.7282 40.1652 20.6096 -6.91059 4.34471 -3.10789 +4395 6 35.1847 31.5046 13.7021 -31.0181 23.9456 -35.1619 +4396 4 34.2309 31.3725 13.4471 24.927 2.88592 7.27171 +4397 4 35.3946 30.8036 14.2945 4.95161 -20.634 19.3451 +4398 6 10.9658 9.01332 39.5058 -15.2714 21.9147 -18.395 +4399 4 10.5965 9.92979 39.4 9.97221 -25.6919 2.69722 +4400 4 11.1763 8.90125 40.4322 -2.36933 4.41176 3.08643 +4401 6 53.2091 4.88966 16.6226 -14.1926 -12.3632 -40.3028 +4402 4 53.7513 5.3458 17.242 7.58091 5.46958 35.753 +4403 4 52.4727 4.38631 17.0042 6.19997 4.37068 9.30068 +4404 6 7.84194 33.803 26.1542 28.433 15.6582 -32.2535 +4405 4 7.6241 34.0763 27.0539 6.31302 8.01731 -0.629847 +4406 4 8.43319 34.4994 25.6777 -29.4311 -29.3345 32.8186 +4407 6 31.3263 27.9445 6.27534 4.23256 -31.0286 -11.1959 +4408 4 31.9071 27.4889 6.92578 -8.71467 11.4818 -6.48617 +4409 4 31.157 27.2952 5.54778 3.06851 13.2477 11.4148 +4410 6 31.3665 2.16522 41.0549 8.67281 8.84877 18.675 +4411 4 31.764 2.22522 0.0553479 -13.0589 -8.62932 -24.7178 +4412 4 31.1679 1.24258 40.8683 -0.324156 -6.15668 4.61941 +4413 6 33.7659 4.25511 35.8987 -17.0312 -3.82062 1.06926 +4414 4 34.343 3.86214 36.5812 -9.75418 2.24627 -3.55813 +4415 4 32.8029 4.08293 36.1352 33.1171 1.27305 -1.46623 +4416 6 47.9658 16.0637 29.8469 2.67107 -7.93457 21.4822 +4417 4 48.7643 16.2814 30.3583 0.589987 0.219824 -12.8585 +4418 4 47.4335 15.6159 30.5321 -1.60863 4.8928 -15.0046 +4419 6 49.3312 10.0914 28.5924 -0.28152 -2.80953 -5.35856 +4420 4 48.5695 10.6519 28.8218 4.15282 -2.34898 -5.74021 +4421 4 49.4995 10.1231 27.6243 -2.44246 2.9592 14.5426 +4422 6 21.4058 27.7857 29.7524 8.26148 -8.5709 13.934 +4423 4 21.8935 27.2574 30.4222 -7.07544 0.199766 -18.4014 +4424 4 21.2999 28.6278 30.1835 -3.48366 18.9655 1.67033 +4425 6 11.6744 39.4982 25.8468 7.90293 7.18169 -2.58674 +4426 4 12.2285 38.7361 26.0681 1.40058 3.92388 1.36909 +4427 4 10.8023 39.1241 25.7384 -12.6269 0.672841 -0.990747 +4428 6 22.9696 39.3076 7.85132 -6.07512 -3.4122 -1.68244 +4429 4 22.2682 38.6524 7.98148 0.173976 5.86283 1.52023 +4430 4 22.7132 40.0561 8.41581 1.67877 -3.24138 -2.90234 +4431 6 42.551 35.9177 31.3369 11.821 -63.1978 11.5341 +4432 4 42.5803 35.466 30.4647 -4.4966 22.226 11.3725 +4433 4 42.4036 36.8376 31.2573 -6.84366 36.9754 -14.9488 +4434 6 33.6582 14.7374 3.97797 20.0935 -7.17859 -40.4554 +4435 4 32.8645 15.2412 4.10613 -20.5582 11.3796 6.05129 +4436 4 33.8494 14.8388 2.99484 -4.26498 -3.76663 30.6135 +4437 6 36.6985 8.59579 17.521 17.5186 -20.4505 -17.8166 +4438 4 37.2174 8.05238 16.87 -10.1577 15.2162 18.3492 +4439 4 36.2061 9.2161 16.9727 -6.85471 3.87096 1.58869 +4440 6 20.8134 32.4132 17.3224 -0.15138 -19.2041 8.32641 +4441 4 20.2101 33.0681 16.9297 -8.31182 -6.81981 10.9196 +4442 4 20.3788 31.7527 17.9441 5.10322 26.2393 -19.6477 +4443 6 20.7088 35.3183 14.0957 -11.7768 -25.3725 -13.8548 +4444 4 21.261 35.5893 13.3574 6.77827 9.37653 -4.07387 +4445 4 20.8679 35.9028 14.8214 6.04206 13.2639 9.85712 +4446 6 20.2377 2.51389 40.1721 -7.12285 -8.41588 24.6249 +4447 4 19.7963 2.31331 41.0421 14.3479 1.04867 -24.2175 +4448 4 20.7189 1.71371 39.9103 -4.456 1.41042 1.49289 +4449 6 15.0332 14.4679 0.20602 13.2809 -6.14192 -34.7112 +4450 4 15.5535 13.6508 41.8516 -13.9549 30.8146 5.37449 +4451 4 15.3124 15.2392 41.5458 -1.11857 -25.4589 11.3055 +4452 6 24.8198 37.3334 18.5262 -9.71694 12.1129 21.4379 +4453 4 24.5044 38.0178 17.9266 6.55828 0.975012 -4.85481 +4454 4 24.4839 37.6255 19.4009 7.37292 -12.3795 -13.3571 +4455 6 3.16023 27.7824 5.25746 -7.59771 -9.49442 8.09122 +4456 4 2.57386 27.9573 6.05068 26.7372 -11.3185 -11.6141 +4457 4 4.04718 27.3724 5.4685 -26.4098 5.90831 3.92345 +4458 6 37.1274 39.059 36.0582 -20.0626 39.3499 3.12364 +4459 4 37.4397 39.697 36.7497 0.155645 -22.9334 -11.3782 +4460 4 37.5741 38.2261 36.1006 18.9616 -13.4483 8.05827 +4461 6 41.3496 16.372 3.85306 -8.55617 -26.9153 -3.74777 +4462 4 41.2863 17.3336 3.84263 10.0449 1.9656 13.5452 +4463 4 42.0245 15.9886 4.46176 -7.16622 24.1057 -6.4954 +4464 6 15.5715 3.1806 35.3543 4.49903 -8.79025 -44.1337 +4465 4 15.0747 3.51322 34.5661 7.45265 -4.29831 20.3405 +4466 4 15.2394 3.62675 36.1076 -11.9729 17.6287 21.2524 +4467 6 33.1697 24.252 7.98021 17.4163 -35.2043 24.5175 +4468 4 33.373 24.4892 7.07941 -5.88693 14.0606 -13.9779 +4469 4 32.5854 24.8767 8.38373 -10.6809 23.5743 -3.02942 +4470 6 35.8792 29.7453 15.5891 -14.351 2.75051 -7.10357 +4471 4 36.7674 29.6271 15.8378 44.9858 5.9786 2.16229 +4472 4 35.4705 29.0828 16.1298 -19.5083 -3.35284 8.18061 +4473 6 17.5951 36.8258 41.8642 -13.8657 0.640745 -39.4401 +4474 4 18.0986 36.7885 0.752491 19.5286 0.61142 14.8967 +4475 4 18.204 36.9888 41.0995 -4.16013 -2.78766 23.3657 +4476 6 26.5622 4.14757 31.1303 -11.2209 -47.8968 -15.8259 +4477 4 27.2883 4.63526 31.456 28.856 27.2634 11.544 +4478 4 26.9475 3.23966 30.9928 -12.9924 23.1667 5.46977 +4479 6 31.9456 1.33308 34.4467 -12.9904 6.64728 -11.4505 +4480 4 32.8071 1.19449 34.8725 -11.0783 -3.65615 8.33208 +4481 4 31.1956 1.0725 35.0172 18.2758 0.413953 2.527 +4482 6 24.503 14.7492 2.38048 9.24208 -0.0712211 -0.802907 +4483 4 24.1928 14.0003 2.93847 14.4388 11.7071 -7.35684 +4484 4 25.4689 14.9243 2.53228 -19.8697 -9.93034 3.69906 +4485 6 25.7634 20.9148 27.525 0.946636 -0.977661 -1.30084 +4486 4 25.4997 20.5428 28.395 3.38508 9.32598 -11.7317 +4487 4 25.6529 21.8806 27.5755 0.284497 -3.23384 4.14496 +4488 6 18.1477 40.1511 30.6505 2.638 -12.7558 5.82509 +4489 4 18.5379 39.2542 30.773 0.361891 20.0487 -3.45439 +4490 4 18.8736 40.7943 30.5754 -0.793328 -5.73314 0.616918 +4491 6 46.8137 23.9108 24.5765 -6.45001 25.2139 -38.2053 +4492 4 46.156 24.4917 24.0674 25.2521 -23.4518 17.6745 +4493 4 47.3533 23.4819 23.8873 -7.92808 3.44465 4.72259 +4494 6 45.5993 22.6806 26.5072 -4.87261 3.12825 -8.14378 +4495 4 46.0946 22.9584 25.7273 -3.42504 -3.72677 5.16847 +4496 4 46.0209 23.1613 27.2227 -5.79148 -3.32105 5.25932 +4497 6 20.0977 4.47574 26.7104 -1.85738 36.2438 14.3308 +4498 4 20.3766 5.37803 26.4593 -10.8474 -9.08605 12.6513 +4499 4 20.6066 3.98633 26.1049 14.7704 -34.5311 -24.6657 +4500 6 35.268 26.6035 12.5547 25.3434 4.5593 25.1203 +4501 4 35.7054 25.7374 12.5354 -13.4481 2.49909 -6.64065 +4502 4 35.8431 27.0669 13.1929 -15.092 1.56141 -12.9558 +4503 6 3.25549 33.9664 12.2985 -21.2488 -6.99508 3.93395 +4504 4 2.30606 33.7392 12.3085 7.5225 -4.25393 -1.25154 +4505 4 3.25844 34.917 12.332 8.53638 16.5693 1.24934 +4506 6 36.6808 1.27299 25.5856 -28.051 -2.86161 17.5249 +4507 4 37.6164 1.46673 25.6835 8.21338 5.71919 3.59986 +4508 4 36.1703 1.6124 26.3685 15.6278 -2.9361 -18.4357 +4509 6 16.8737 4.664 24.0353 -31.9925 -2.01789 -27.2632 +4510 4 15.8786 4.73848 23.8401 40.5517 -2.65221 8.73903 +4511 4 17.2589 4.19458 23.2519 -3.48506 7.68373 17.7614 +4512 6 39.6701 15.0742 7.83356 -1.71206 -7.05123 2.14494 +4513 4 39.2725 14.2274 8.02711 2.44544 -9.24519 17.4119 +4514 4 39.3892 15.1326 6.9218 7.69265 14.011 -7.76766 +4515 6 9.96731 20.1909 2.92864 -13.1382 1.0323 -16.144 +4516 4 9.71565 20.5309 2.05786 3.65664 7.03968 6.64426 +4517 4 9.8995 19.2377 2.78093 4.24026 5.10291 12.3576 +4518 6 23.4077 4.6159 15.27 -3.48308 -16.1533 -1.5067 +4519 4 23.619 4.71624 14.3536 6.29203 -7.01184 -22.1313 +4520 4 23.1672 5.50294 15.4683 -4.33935 19.8524 20.6561 +4521 6 23.5267 41.6518 17.9122 -9.44104 0.807914 21.3506 +4522 4 23.7067 41.2659 18.7956 7.59245 -0.294373 -11.029 +4523 4 22.6339 0.0834245 18.0732 1.82991 3.48892 -13.1537 +4524 6 30.9316 4.82324 1.33107 45.9774 51.3713 7.99935 +4525 4 30.5768 4.02682 1.05687 -28.0042 -54.4029 -17.3695 +4526 4 31.8094 4.8761 0.879215 -15.6392 -0.833181 8.5221 +4527 6 29.2201 33.7587 18.5991 58.073 2.92721 -1.85527 +4528 4 30.1837 34.1183 18.6008 -42.2538 -17.2347 0.0641557 +4529 4 28.6837 34.5413 18.5643 -15.6262 17.5996 3.33909 +4530 6 23.1221 16.7099 3.68521 11.8431 -16.3115 0.0733348 +4531 4 23.6562 16.338 2.95547 -9.45134 2.67217 9.8165 +4532 4 23.048 17.6538 3.54099 -2.31098 6.59774 -1.54538 +4533 6 34.8961 26.7639 31.7325 -1.99602 4.46994 3.67284 +4534 4 35.0929 27.7139 31.562 -2.18198 -17.8875 -5.58085 +4535 4 35.0252 26.2302 30.9312 2.47742 18.1005 -1.54363 +4536 6 7.11189 40.7663 20.959 14.901 4.90705 15.7674 +4537 4 6.49418 40.4573 20.3006 -5.17655 -2.88906 -15.6427 +4538 4 7.9749 40.9101 20.5297 -6.61986 -3.78335 -7.15935 +4539 6 52.4451 9.69387 11.9379 -8.46192 -13.0679 -16.1645 +4540 4 52.1167 8.90553 11.4509 5.46474 18.3719 13.4625 +4541 4 53.1134 10.0871 11.3593 -6.16158 -0.354597 4.80602 +4542 6 12.0344 32.7576 27.7445 1.28323 7.36678 12.5499 +4543 4 11.2848 32.2741 27.3627 7.37999 2.33687 -5.47139 +4544 4 12.7987 32.654 27.1746 -1.40521 -5.62475 -4.84597 +4545 6 15.7821 18.5441 0.84801 8.76354 -4.35468 -11.8188 +4546 4 16.4439 18.9467 1.42581 -3.0166 1.81121 1.10538 +4547 4 14.9492 18.5892 1.29924 -12.8156 0.756803 9.02992 +4548 6 30.9925 13.9418 7.42386 -4.40747 -9.92517 -19.1249 +4549 4 31.0137 13.4754 6.53341 6.38174 17.9129 28.0089 +4550 4 31.6996 14.6103 7.52177 -5.32565 -11.3142 -7.68087 +4551 6 23.9405 39.5605 3.5435 10.8606 -6.43074 -8.73391 +4552 4 24.3095 38.7805 4.04208 -2.00396 18.4511 -18.0645 +4553 4 24.6123 39.8651 2.88148 -9.69774 -9.50421 15.8523 +4554 6 53.2462 13.9551 2.00337 -15.5118 -12.0942 -3.71099 +4555 4 54.104 14.269 2.28215 12.5804 5.35006 1.30654 +4556 4 53.0522 14.3304 1.13281 7.32968 -0.777694 2.32044 +4557 6 29.4483 26.4268 7.81741 -0.171572 11.4439 -18.4732 +4558 4 29.8672 26.7876 7.00927 -3.33338 -4.99995 18.6366 +4559 4 28.5088 26.3872 7.58736 -4.03891 -2.78124 5.15679 +4560 6 24.6251 23.6043 31.0935 -26.8137 17.7603 -44.4691 +4561 4 23.7139 23.2229 30.9355 29.773 11.0738 8.78977 +4562 4 24.7983 24.2076 30.2965 -2.98074 -30.8217 36.523 +4563 6 33.658 19.3188 40.511 -4.29932 4.0975 7.85681 +4564 4 33.8365 18.6271 41.1728 0.0947513 0.993086 -5.72158 +4565 4 34.3002 19.2334 39.7953 0.390848 -1.03282 -3.03706 +4566 6 0.558986 35.9852 14.2205 11.1667 11.0015 21.0521 +4567 4 1.21386 36.1432 14.9149 3.92292 -5.96876 -2.97707 +4568 4 0.043734 36.7876 14.3014 -15.3768 6.08493 -10.5247 +4569 6 7.05222 12.7587 15.7802 -26.1824 -15.4106 14.8382 +4570 4 6.35773 12.5373 16.4499 19.2033 7.53925 -13.5919 +4571 4 6.88557 12.0803 15.1093 4.12905 5.75416 0.888 +4572 6 7.8802 3.87979 22.4264 4.564 -30.6165 13.1651 +4573 4 7.61737 4.55637 21.8154 -5.12813 13.4305 -13.5146 +4574 4 7.59435 3.01808 22.0419 3.92228 16.9329 8.71162 +4575 6 50.747 32.0919 16.246 0.584829 29.9532 -6.88448 +4576 4 49.8575 31.8158 16.477 -3.66132 0.0213613 -0.234359 +4577 4 50.6533 33.048 15.9617 2.92819 -31.696 10.1835 +4578 6 15.3083 18.2099 30.0577 17.4273 -12.3999 25.5818 +4579 4 14.8795 18.523 29.2753 -13.2188 2.60124 -19.4058 +4580 4 14.9888 17.3027 30.2404 2.47215 8.3937 -6.40515 +4581 6 36.7253 25.4508 33.3862 -30.1432 30.6395 -17.6873 +4582 4 35.9871 25.9696 32.8546 42.334 -36.2451 27.5582 +4583 4 36.7428 24.5171 33.143 -7.68133 1.91065 -3.3758 +4584 6 16.5208 21.8449 20.262 -11.2097 8.64672 -3.63533 +4585 4 16.6085 20.9267 19.9682 1.68058 -0.497742 -2.90804 +4586 4 16.3112 22.3946 19.4823 4.36577 -8.59001 6.07269 +4587 6 44.2833 3.11948 30.0766 -7.99673 -6.73576 30.9987 +4588 4 44.2005 2.2232 29.7402 -0.794022 -7.70278 -4.62871 +4589 4 44.5183 3.67066 29.3503 7.77568 15.2131 -24.9404 +4590 6 51.0808 14.1269 27.7758 -27.047 -14.2895 -4.28411 +4591 4 51.175 15.071 27.7901 8.66575 19.7266 0.878182 +4592 4 50.1173 14.0309 27.5969 15.0189 -4.76366 3.10402 +4593 6 54.1497 15.8755 27.1203 10.9044 -5.07506 15.753 +4594 4 54.6247 15.0341 27.411 -19.35 18.5916 -21.6107 +4595 4 53.6213 15.8397 26.2863 11.6919 -13.2292 13.7718 +4596 6 26.7269 15.1716 34.5247 3.07047 6.28357 -2.56105 +4597 4 26.6547 16.15 34.5201 9.87746 -16.6036 -4.19036 +4598 4 27.4477 14.9176 33.917 -5.54963 13.4877 1.89491 +4599 6 34.6713 2.21044 27.481 35.3652 -9.42756 14.1603 +4600 4 34.3712 2.0217 28.3795 -9.10436 3.38048 -0.887416 +4601 4 33.9282 2.37922 26.9258 -24.4077 6.67858 -6.22498 +4602 6 36.3012 17.6491 40.388 5.86113 23.4658 6.44349 +4603 4 35.7206 17.1804 39.7974 -3.43874 -12.7236 -2.47465 +4604 4 36.6864 17.0408 41.0377 -6.22241 -0.114851 -7.42509 +4605 6 26.2819 0.194243 33.0916 -21.1162 -1.74839 5.89968 +4606 4 26.0541 0.792538 33.818 7.17118 8.51167 2.05738 +4607 4 25.4361 41.6393 33.0097 0.772233 -7.73624 -3.23605 +4608 6 5.19547 35.5715 31.6247 14.6733 -21.492 26.4929 +4609 4 6.10271 35.831 31.8735 -9.75028 2.17691 -1.53344 +4610 4 4.97694 36.0548 30.8519 -3.41417 18.4244 -29.6169 +4611 6 20.2195 22.0294 35.119 8.25657 -3.203 11.321 +4612 4 19.9286 21.1888 34.7559 -2.68712 -4.78598 1.15285 +4613 4 20.5567 21.7901 36.0152 -5.29706 4.10974 -20.8318 +4614 6 15.9087 36.5843 36.9399 0.69981 -30.9087 31.3945 +4615 4 16.5764 37.2836 37.0377 -3.33596 -3.14632 -1.27145 +4616 4 16.032 35.9777 37.754 -5.87689 21.7482 -34.0408 +4617 6 30.95 22.3912 3.57027 12.227 -51.3484 -20.5494 +4618 4 31.0645 22.6091 4.4902 1.82476 2.59415 19.1922 +4619 4 31.2691 21.4218 3.50648 -13.7255 40.3499 2.75328 +4620 6 47.0405 8.41049 14.2025 -7.26712 -13.7585 -23.7685 +4621 4 46.2225 8.31623 13.6472 18.9804 2.55096 13.7682 +4622 4 47.7321 7.85584 13.7597 -18.0416 11.4216 8.02226 +4623 6 34.1106 18.627 3.15563 -0.4946 23.1394 22.2065 +4624 4 34.672 18.2914 3.86301 0.996255 -3.71784 -4.49801 +4625 4 34.2399 18.1173 2.36738 0.542984 -13.2578 -17.3669 +4626 6 26.7976 25.3916 12.343 -23.6037 -44.5624 17.4882 +4627 4 27.2059 26.2338 12.4335 13.1462 29.8808 4.32264 +4628 4 26.6887 24.995 13.243 7.37483 11.5945 -21.6739 +4629 6 22.6215 25.7777 30.8835 17.9212 -8.3502 11.6983 +4630 4 23.3826 25.7056 31.4928 -6.70991 6.16838 -4.71983 +4631 4 22.2455 24.8881 30.8847 -4.10822 -0.13742 -3.2228 +4632 6 23.6315 9.78689 35.7599 5.48292 -2.30097 -0.625566 +4633 4 22.8113 10.2893 35.7248 -4.77612 1.7474 -0.383276 +4634 4 23.3643 8.87406 35.5171 2.31753 16.9109 3.97959 +4635 6 10.4044 36.7742 9.63922 -25.0741 -4.1625 3.51028 +4636 4 9.48479 36.4361 9.55892 17.1497 7.1291 1.06445 +4637 4 10.7029 36.9295 8.73946 3.49181 4.27039 -8.54773 +4638 6 4.00239 32.4234 25.8687 17.3833 10.7639 11.9139 +4639 4 4.35688 32.9952 25.1699 -1.7627 -0.965582 -1.95819 +4640 4 3.3252 31.8731 25.4905 -12.2764 -14.2405 -10.2138 +4641 6 29.0717 26.0252 18.6551 27.2015 -27.7815 2.54409 +4642 4 28.1485 25.9947 18.9226 -9.28828 -8.18845 2.68073 +4643 4 29.5616 25.1801 18.9271 -24.0321 31.3207 -7.4501 +4644 6 15.3034 1.33037 27.9713 -8.15532 13.2931 -1.88459 +4645 4 14.9824 0.900448 27.1643 -4.10476 8.37726 9.18093 +4646 4 14.8435 2.19317 28.1161 8.64797 -17.4448 -9.70896 +4647 6 48.6122 2.88813 22.9601 -14.0575 20.6462 10.9468 +4648 4 48.3097 2.01316 22.7294 4.97712 -8.72373 -1.92059 +4649 4 49.4728 3.0448 22.5739 5.56154 -9.57595 -10.4155 +4650 6 53.0134 0.348391 19.7218 2.72624 -2.60203 -3.14968 +4651 4 52.5877 42.0257 20.5538 -0.625041 0.289898 3.74318 +4652 4 52.305 0.305612 19.0628 -0.905041 -0.864478 -1.55308 +4653 6 1.39118 17.4858 17.9447 -8.50794 14.6458 12.7327 +4654 4 1.24353 17.4779 16.9894 -1.31782 -10.0732 -1.96873 +4655 4 1.47925 16.6123 18.3551 -1.8326 -9.29856 -10.4725 +4656 6 37.8975 19.0277 37.6053 -28.6618 15.029 -11.7184 +4657 4 36.9647 18.7897 37.7838 11.6122 1.96204 1.16191 +4658 4 38.4406 18.4447 38.1174 10.3965 -16.3488 12.6679 +4659 6 26.9855 30.3558 38.071 9.50079 1.40194 -4.36533 +4660 4 26.0886 30.216 37.7369 5.39533 7.19535 -1.12484 +4661 4 27.2954 31.2276 37.7499 -13.0308 -11.5285 -0.168161 +4662 6 20.0885 18.5747 3.04679 -6.02291 21.5949 -15.2672 +4663 4 19.9787 17.7407 3.50085 7.53739 -11.7285 12.3408 +4664 4 20.8981 19.0299 3.33477 -4.38138 -14.9723 0.744253 +4665 6 35.0861 6.94018 4.08702 3.04221 -3.62035 -0.583554 +4666 4 35.6351 7.18342 3.33325 6.4301 -2.1748 -2.62446 +4667 4 34.2564 7.39563 3.93984 -10.6534 0.652929 2.2495 +4668 6 22.2213 37.08 31.2556 -28.1532 13.1327 42.6182 +4669 4 22.1563 36.8958 30.3458 -2.68084 -5.78815 -35.014 +4670 4 21.2899 37.3194 31.5407 35.2494 -6.03647 -12.8067 +4671 6 12.3954 22.364 41.8234 21.4337 26.9075 -8.21443 +4672 4 12.9612 23.1595 41.5956 -22.2624 -27.6618 12.5485 +4673 4 11.7092 22.295 41.1522 0.74395 2.83494 0.343647 +4674 6 43.2331 30.3213 23.157 26.8689 32.5799 1.85734 +4675 4 44.1495 30.0558 22.8796 -21.7207 5.89602 6.32158 +4676 4 43.3514 31.2801 23.4416 -6.45211 -30.9956 -6.78246 +4677 6 16.5257 8.07813 16.6617 -19.4309 -12.5216 11.6481 +4678 4 16.3886 8.34983 15.7476 7.00958 2.01583 -5.14722 +4679 4 17.4107 8.32004 16.9428 8.9294 8.4681 -2.86418 +4680 6 10.0506 8.65043 31.7756 -2.39508 10.2278 -10.4865 +4681 4 10.14 7.97578 32.4103 1.95442 -36.8206 12.1998 +4682 4 10.116 9.39125 32.3649 -0.107045 27.388 0.472024 +4683 6 10.1509 6.49695 25.6483 14.6726 -6.33183 2.00995 +4684 4 9.37694 6.15153 26.0805 -12.3653 -8.75157 5.1154 +4685 4 9.82248 7.1865 25.0601 3.70088 -0.958502 2.30736 +4686 6 49.8668 7.2369 25.5225 -24.0329 9.97804 -6.35029 +4687 4 50.053 6.31696 25.3599 8.14544 -13.6468 -2.92498 +4688 4 50.6696 7.6642 25.7982 18.0374 4.82749 5.17198 +4689 6 18.4641 37.5693 33.932 -1.74635 9.46172 -1.89257 +4690 4 17.7617 38.2474 34.0853 10.1616 -18.2299 -3.47398 +4691 4 18.0542 36.6946 34.0238 -8.30855 4.53024 1.19921 +4692 6 32.1897 34.7964 39.2558 32.2313 -17.5381 13.0656 +4693 4 32.48 34.3381 40.0896 -7.23509 10.7133 -18.5379 +4694 4 31.2879 35.0284 39.3813 -31.6037 5.0658 8.82 +4695 6 49.5304 23.9104 4.45569 25.8701 3.67026 -38.321 +4696 4 49.7808 23.1947 5.01942 4.2809 -18.8946 17.0996 +4697 4 48.8132 24.3493 4.85794 -31.8244 16.1567 21.064 +4698 6 6.0606 24.4992 33.9345 -0.638471 -2.64646 7.7036 +4699 4 6.7001 23.7849 33.7997 2.17947 5.97399 -8.00372 +4700 4 5.47521 24.1274 34.6146 -0.567039 8.82042 -5.77933 +4701 6 1.71497 22.9937 24.1827 2.23241 21.1509 -1.27791 +4702 4 1.62302 23.9425 23.95 -0.486435 -10.8617 3.92094 +4703 4 0.825214 22.7289 24.4403 -5.44701 -4.12175 2.39318 +4704 6 12.4657 16.5565 32.3481 -44.3953 42.3465 -23.9812 +4705 4 13.2256 16.0186 32.4214 25.6927 -27.9273 24.4997 +4706 4 11.8347 16.6394 33.1026 23.5286 -12.3088 -0.369419 +4707 6 21.3722 37.3857 27.9432 8.33623 1.67622 30.3175 +4708 4 21.2745 37.3852 27.0022 -8.47587 6.30229 -26.1478 +4709 4 20.7646 38.0573 28.2974 0.343549 -1.37388 -6.67046 +4710 6 27.2371 40.835 28.8059 -14.5618 2.70883 26.0148 +4711 4 26.5104 41.4636 28.9519 7.17104 -1.72995 -14.6333 +4712 4 27.2442 40.3637 29.6524 5.83721 -3.62297 -8.28664 +4713 6 0.999535 21.7321 13.5318 -29.3194 4.17708 -0.571391 +4714 4 1.85706 21.6318 13.8745 50.1621 -4.04822 5.83187 +4715 4 0.493313 21.4968 14.3164 -12.4374 2.61082 -2.41507 +4716 6 22.3196 2.57547 8.74609 19.5097 -5.43411 17.7027 +4717 4 22.9517 3.10624 8.26305 13.4452 6.72454 -0.92593 +4718 4 21.5477 2.63817 8.2102 -22.9662 -0.14239 -10.9727 +4719 6 29.9886 17.8486 8.24374 -1.93571 4.49032 -2.67939 +4720 4 29.0601 17.6146 8.32603 -5.42798 -1.41354 1.1127 +4721 4 30.4131 17.4547 9.01282 4.29332 -3.23535 5.29369 +4722 6 3.62824 37.7086 25.7053 -21.3362 8.32154 -6.60892 +4723 4 4.42904 37.184 25.8405 -4.94962 -9.47676 -0.42012 +4724 4 2.83762 37.1591 25.4673 21.6133 3.65171 5.88982 +4725 6 26.7972 27.6476 36.3581 -47.4115 -5.5291 12.7506 +4726 4 26.8465 28.2624 35.6306 8.29087 8.74477 -10.4705 +4727 4 25.8218 27.6191 36.6005 30.1762 -0.597939 -6.56813 +4728 6 13.3509 25.3111 38.1214 6.90903 -15.9492 13.2692 +4729 4 13.3459 24.3911 38.4732 0.919555 17.3618 -5.73458 +4730 4 14.144 25.7168 38.5298 -8.43807 -1.25323 -5.48633 +4731 6 49.7161 27.2636 6.73274 -18.8339 5.2299 -32.7408 +4732 4 49.5935 26.3653 6.40806 5.58405 -0.645115 8.82912 +4733 4 49.2001 27.7791 6.04852 15.3529 -4.94049 26.886 +4734 6 39.7451 11.5811 10.2076 8.75523 -9.51322 -11.6408 +4735 4 40.371 10.9447 9.80262 -5.32314 14.1891 9.76509 +4736 4 39.1233 11.799 9.49079 2.50191 2.43793 7.76023 +4737 6 17.4883 24.9894 35.5591 -19.4762 1.01983 7.35275 +4738 4 17.0975 24.7887 34.694 2.72786 0.423626 1.28381 +4739 4 18.4353 24.8575 35.5073 10.004 -2.92602 -7.93295 +4740 6 45.0832 34.9807 31.8277 24.5651 -3.79623 6.38158 +4741 4 44.3095 35.5111 32.0501 -8.6141 -4.27399 -12.5931 +4742 4 44.9123 34.3632 31.1055 -12.5508 0.508806 -0.453023 +4743 6 30.2187 9.89463 31.3271 7.05348 4.55507 6.68413 +4744 4 30.4541 10.7656 30.9635 -3.12777 -8.04008 8.45875 +4745 4 30.1355 10.0083 32.293 1.90576 1.32601 -8.54322 +4746 6 32.3712 9.2149 6.61373 28.8381 -35.7198 -39.9492 +4747 4 32.1726 8.66567 5.78496 5.01502 20.0116 29.9298 +4748 4 31.5547 9.49954 6.96481 -36.3246 12.521 14.22 +4749 6 9.26959 24.9556 35.9161 1.96832 15.842 -17.2096 +4750 4 8.91298 25.4858 35.1726 -0.127744 -15.1166 11.0351 +4751 4 9.85583 25.5957 36.3463 -2.24606 -10.0757 2.02076 +4752 6 40.3298 1.49261 18.8755 10.6299 1.30292 -21.7 +4753 4 39.6194 1.80532 19.3944 -35.8146 17.5344 12.5449 +4754 4 40.7796 0.936194 19.4956 21.1502 -18.4862 6.40423 +4755 6 5.26901 10.6323 30.4328 -1.07618 -0.575959 25.8078 +4756 4 5.0059 11.4532 29.9824 1.00544 3.53991 6.4134 +4757 4 5.36238 10.8297 31.4225 -4.75078 2.46468 -31.0333 +4758 6 25.6472 11.7043 25.6564 -2.85241 -30.912 5.54365 +4759 4 25.9319 12.4737 26.1319 5.23872 14.1859 6.15637 +4760 4 25.9893 10.9537 26.204 -5.41829 19.961 -14.7301 +4761 6 21.91 20.0664 29.7913 -6.2328 1.4725 0.460556 +4762 4 22.5319 20.0532 30.5545 -13.0709 -9.05965 -9.53591 +4763 4 21.5487 19.1817 29.5606 11.8355 8.09924 7.60661 +4764 6 10.008 19.9919 34.5046 11.2891 -12.0839 -11.2138 +4765 4 9.40296 20.4589 35.0806 -5.60052 -0.834193 8.04722 +4766 4 10.0208 19.0442 34.745 -1.06298 11.667 -2.12072 +4767 6 24.6334 10.3662 12.209 5.25257 18.8662 20.0118 +4768 4 24.6941 9.47775 12.5956 1.57271 8.96717 -2.9517 +4769 4 24.9719 11.0034 12.9045 -11.2568 -27.0384 -15.8586 +4770 6 50.4496 28.283 11.5446 48.5969 7.21476 -25.6728 +4771 4 51.3012 28.7385 11.2434 -32.0883 -19.6524 11.3949 +4772 4 50.1145 28.8771 12.2081 -10.2548 6.02908 11.3498 +4773 6 13.9159 27.6234 25.0588 -25.6331 11.4059 -15.4978 +4774 4 13.5005 28.0493 25.83 5.93925 -3.01588 -8.8098 +4775 4 13.4276 28.0022 24.2718 14.6036 -12.4854 23.8457 +4776 6 46.1589 18.6653 40.4078 -23.2184 -0.389309 -10.7846 +4777 4 45.2349 18.5626 40.0761 15.1795 0.391647 5.46432 +4778 4 46.2048 19.5984 40.6658 -0.558864 -5.77386 -4.91212 +4779 6 32.4746 14.176 27.1227 -16.003 2.1806 5.505 +4780 4 31.9042 13.6172 27.6867 7.52463 5.83279 -7.70325 +4781 4 32.1655 15.0897 27.2802 4.78128 -6.53963 -2.41902 +4782 6 14.0556 36.3553 13.3828 19.8073 6.5728 22.6139 +4783 4 14.1017 37.3298 13.5875 -14.1879 -23.5484 -13.1576 +4784 4 13.3212 36.1206 12.8052 -8.41953 14.8686 -5.40295 +4785 6 1.88392 36.5802 21.9963 -4.52806 -9.18778 1.34501 +4786 4 1.78058 36.5165 22.9531 -3.13652 -1.22736 7.08711 +4787 4 2.81062 36.8013 21.8509 3.08344 1.49572 -0.20158 +4788 6 25.283 31.8665 39.7486 -0.0346121 -4.3463 21.3102 +4789 4 24.9491 32.7147 39.4474 -1.97702 6.83441 1.95234 +4790 4 25.5262 31.9404 40.7015 -5.12155 2.92558 -20.0537 +4791 6 6.47988 22.0137 1.28428 -12.6715 -7.61279 -4.66874 +4792 4 5.53909 21.8738 1.48571 10.6555 3.73696 2.93659 +4793 4 6.5727 22.8978 0.916948 1.0061 5.37498 -0.183021 +4794 6 27.6236 25.0404 4.70626 6.00578 18.2896 15.2827 +4795 4 28.5331 25.4118 4.61276 -17.9968 -6.47987 4.19831 +4796 4 27.2352 25.3966 5.54825 13.7859 -6.49357 -18.8943 +4797 6 21.6401 30.9371 41.2305 6.69834 21.9548 -27.1087 +4798 4 21.276 30.3289 41.855 -17.7491 -18.0709 13.8774 +4799 4 21.0024 31.0127 40.4783 8.64888 -5.56942 17.5854 +4800 6 32.355 18.8729 12.7674 13.4209 4.31066 2.75957 +4801 4 31.3956 18.9706 12.835 4.55688 -5.10905 -10.5867 +4802 4 32.607 18.5493 11.8826 -7.53687 3.28724 6.30822 +4803 6 35.6452 19.4617 21.1556 -9.82604 19.2175 8.60555 +4804 4 35.3405 18.5718 21.3708 -2.26659 -3.59924 -3.4629 +4805 4 34.936 20.0876 21.4701 16.8427 -19.1907 -7.36791 +4806 6 27.6904 17.9595 34.0135 2.51947 12.848 9.8691 +4807 4 28.1207 18.371 33.2456 -3.55582 0.0466306 5.59907 +4808 4 28.0719 18.4525 34.7708 -4.77519 -7.99763 -12.3529 +4809 6 34.1913 39.0308 14.8198 -32.2909 7.81486 42.3772 +4810 4 33.7378 38.3849 14.2709 2.40292 -0.641653 -5.60016 +4811 4 33.4938 39.1934 15.5434 31.6198 -1.67931 -26.5413 +4812 6 28.5078 3.47132 33.888 -4.80695 9.04662 2.15546 +4813 4 27.9441 4.2497 33.8725 -11.1427 -2.20885 -1.07295 +4814 4 29.3801 3.85895 33.8332 18.6007 -6.2612 -1.20104 +4815 6 34.9259 32.1312 6.54177 -41.0464 -12.9808 21.9467 +4816 4 34.0171 32.0297 6.98271 38.7419 4.2921 -24.6555 +4817 4 35.5211 32.1736 7.29951 5.76537 -1.35874 -3.25655 +4818 6 31.8896 6.8799 23.5232 0.89208 3.44668 5.58958 +4819 4 32.4231 6.58347 22.7679 -0.16899 1.4285 3.8543 +4820 4 32.2407 7.75715 23.7826 1.29066 -6.24882 -6.25814 +4821 6 18.8559 1.76458 0.828337 -20.5472 23.3683 -17.7838 +4822 4 18.0266 2.11952 0.42761 13.2396 -12.575 3.84382 +4823 4 19.0445 2.38904 1.53279 3.18086 -1.81057 9.578 +4824 6 26.9929 18.9294 11.856 68.8676 -4.65359 -28.5611 +4825 4 27.3133 19.7685 11.4551 -15.5879 -7.28987 7.59546 +4826 4 26.1136 18.988 12.1267 -55.7646 13.8464 15.3945 +4827 6 43.8351 11.1458 18.4443 23.0031 -19.5153 4.50837 +4828 4 43.638 10.8812 17.5537 -13.1544 4.18059 -17.1583 +4829 4 44.5589 10.5175 18.6246 -1.75483 13.9327 9.72942 +4830 6 33.4946 40.5615 37.6755 15.4013 8.76106 -9.33396 +4831 4 34.0096 40.2689 38.4502 -12.4229 -1.46966 -1.83753 +4832 4 32.5786 40.2698 37.7667 -1.95229 -4.85928 9.55413 +4833 6 15.6186 26.7023 39.419 -29.2453 -49.1617 7.39509 +4834 4 15.4971 26.9949 40.3155 1.17426 12.5786 14.7177 +4835 4 16.1446 27.3092 38.9602 29.5915 33.502 -22.8309 +4836 6 4.38071 13.8775 40.883 9.27553 -14.126 -4.37485 +4837 4 5.31782 13.6454 41.0342 -11.8393 4.50398 0.960258 +4838 4 4.04834 13.2497 40.2173 2.13772 10.7877 7.68198 +4839 6 20.1656 10.4005 38.218 10.8779 4.82467 -13.4554 +4840 4 20.4848 10.7245 37.3555 -10.2589 -5.36296 0.708096 +4841 4 20.9923 10.2607 38.6798 -1.28838 -2.71386 11.844 +4842 6 15.1666 19.24 23.8849 4.49083 -8.21488 3.46045 +4843 4 15.3253 20.1347 24.2296 -1.0797 -1.90309 -4.08137 +4844 4 15.0239 19.3391 22.9299 0.969961 5.53483 11.956 +4845 6 47.8934 28.614 15.7995 12.3109 16.1315 8.54118 +4846 4 47.9523 27.7003 15.5425 0.10403 -15.196 -3.00888 +4847 4 48.6265 28.752 16.4246 -6.57835 -5.21115 -6.70139 +4848 6 29.9259 30.9075 18.965 7.62461 4.23841 -1.37457 +4849 4 29.1117 30.4308 18.7732 -7.06282 -5.88302 -2.4339 +4850 4 29.7134 31.8391 18.8515 -2.57834 1.4724 1.74445 +4851 6 11.9338 35.8178 28.497 -7.27451 6.14295 -10.3733 +4852 4 12.5041 35.9802 29.2427 6.70347 11.4983 16.16 +4853 4 12.1847 34.9375 28.2428 -3.53576 -18.0038 -9.26428 +4854 6 29.972 37.8772 25.486 -12.1052 4.73031 -22.3992 +4855 4 30.2553 36.9663 25.6711 3.40868 8.54106 4.83275 +4856 4 30.3747 38.5051 26.0898 8.03536 -1.45294 10.6494 +4857 6 52.6584 28.1048 32.275 31.4311 4.91254 4.04956 +4858 4 52.2473 28.8547 31.8392 -9.38068 2.35947 -3.12986 +4859 4 53.5924 28.4001 32.3224 -6.05351 -9.99886 1.81474 +4860 6 37.0156 40.0823 11.982 15.2095 -8.99172 -8.52195 +4861 4 36.22 40.5624 12.1833 -15.2617 4.79593 6.40041 +4862 4 37.4101 39.8767 12.8402 0.665617 -0.484924 4.09883 +4863 6 16.6662 16.7824 36.4899 -23.6543 20.4081 -13.3107 +4864 4 16.0299 17.4889 36.7962 20.061 -22.8424 -10.9222 +4865 4 16.728 16.9177 35.5139 -3.3638 -0.555369 18.7216 +4866 6 27.9984 4.17668 38.8431 -6.8633 -1.77316 4.22536 +4867 4 28.9161 4.3061 39.1095 4.06977 1.67187 2.70396 +4868 4 28.0368 3.69267 38.0106 -3.95018 -5.40445 -5.6405 +4869 6 28.9057 0.266004 17.7212 -6.10073 29.2375 -5.44551 +4870 4 28.1786 0.88303 17.5246 8.92385 1.95552 -1.67076 +4871 4 28.4447 41.3635 17.8399 -11.0591 -30.1495 5.35559 +4872 6 22.9291 20.1009 26.2737 12.905 2.01461 18.3128 +4873 4 23.6265 20.0378 26.9508 -1.05622 -6.52034 -10.1156 +4874 4 22.4706 20.8929 26.5742 -3.00423 3.39878 -4.61403 +4875 6 49.3993 29.9017 13.433 -6.38025 27.1117 -0.919919 +4876 4 49.1201 30.8275 13.1802 1.84527 -26.9682 8.98406 +4877 4 48.7504 29.5045 14.041 1.51099 8.43883 -0.914593 +4878 6 2.44855 24.8301 7.30401 -10.5471 2.4163 20.698 +4879 4 2.41495 24.6588 8.2845 -1.1432 9.4633 -23.8545 +4880 4 1.72338 25.455 7.1058 6.30785 -9.44609 7.39061 +4881 6 30.3915 26.4508 14.3344 -6.38639 41.9339 41.7386 +4882 4 31.0669 26.3804 15.0403 -0.162406 -14.5956 -15.076 +4883 4 29.932 27.2875 14.6522 8.5071 -34.3491 -22.1885 +4884 6 27.0361 32.5047 3.13805 -13.013 14.5566 5.91638 +4885 4 26.4776 33.1542 3.63465 13.8957 -14.3888 -12.6314 +4886 4 27.3381 31.8882 3.81715 0.997102 -1.94867 -0.811892 +4887 6 34.2693 14.8073 1.28197 14.9869 -24.9335 -24.2287 +4888 4 35.1732 14.4308 1.1613 -12.3133 12.1546 9.27146 +4889 4 33.7818 14.2606 0.617478 5.51233 18.0169 18.4334 +4890 6 30.0243 8.54272 1.33127 -15.3984 1.11418 15.9731 +4891 4 29.9557 9.47917 1.12547 1.89625 5.05184 -1.94546 +4892 4 29.278 8.4251 1.95594 13.4411 -5.55834 -8.66406 +4893 6 42.5535 11.5155 27.7085 15.437 -3.44919 -13.726 +4894 4 42.3225 12.4337 27.8881 -6.79772 -1.02898 5.45325 +4895 4 41.899 10.9203 28.077 -14.0379 1.06089 7.70623 +4896 6 52.4658 39.5603 17.8381 6.64956 -28.6351 -32.0971 +4897 4 51.7413 39.7621 18.3991 -22.9429 13.2738 25.1291 +4898 4 53.1708 40.1592 17.9962 19.9289 22.995 10.0024 +4899 6 33.211 4.92827 31.629 -12.2211 32.167 9.39859 +4900 4 32.8163 5.83971 31.6275 7.84415 -21.2817 2.59476 +4901 4 32.9135 4.52627 30.8083 -0.68235 -2.18314 -5.10952 +4902 6 6.29493 15.9859 18.7482 13.6791 10.985 9.78561 +4903 4 5.93033 16.6016 19.4273 2.88753 -17.718 -13.1605 +4904 4 5.60754 15.3724 18.4768 -10.6912 0.909102 4.08099 +4905 6 8.51749 14.5386 24.6879 -5.02573 1.07483 -2.93277 +4906 4 9.38168 14.4087 25.0828 4.4136 1.3116 3.34168 +4907 4 8.20169 13.6557 24.4566 1.37146 0.850768 1.15416 +4908 6 22.6856 10.1159 32.1347 3.63858 -5.5341 -7.29103 +4909 4 22.4401 11.0127 32.2731 -27.0162 20.0988 15.0061 +4910 4 23.4682 10.3148 31.6383 25.2173 -15.197 -13.8617 +4911 6 11.2884 2.11431 14.6724 -33.0968 -7.95794 -19.898 +4912 4 10.3134 2.08073 14.4479 21.8664 -1.34414 10.3974 +4913 4 11.7152 2.30811 13.8211 9.70644 2.30495 0.939267 +4914 6 44.9099 15.5878 36.2745 25.7257 2.41581 -13.4012 +4915 4 45.0546 15.5553 35.3019 -10.2235 2.9059 20.3658 +4916 4 43.9848 15.4747 36.4307 -17.7944 -2.84066 -0.111047 +4917 6 9.72168 19.0116 31.2214 10.0341 -21.2505 -12.9994 +4918 4 10.5925 19.389 31.3727 0.996524 0.534629 3.32861 +4919 4 9.08651 19.5363 31.6795 -15.0033 12.5653 12.9482 +4920 6 51.9861 7.59179 16.6767 -2.21949 13.5197 0.492591 +4921 4 52.6037 6.8327 16.6765 -16.3843 6.63384 -16.8766 +4922 4 51.5083 7.75362 15.8118 21.6515 -16.4571 17.7861 +4923 6 31.4364 34.7816 36.4086 3.08769 21.0155 -3.2672 +4924 4 31.7704 34.8477 37.2975 8.82098 -13.2304 13.8104 +4925 4 31.3443 35.7177 36.1951 -3.32863 3.82124 -15.3061 +4926 6 4.22848 15.0876 15.3675 -15.1793 -4.71932 15.5862 +4927 4 4.10446 14.9036 16.3273 5.02277 2.80423 -15.2934 +4928 4 5.16622 15.2495 15.2447 10.6913 1.67801 0.337818 +4929 6 47.7535 20.6847 28.0297 3.73811 3.24498 -1.95167 +4930 4 47.6703 19.7739 27.6852 3.21079 12.9013 3.0329 +4931 4 48.3469 21.1738 27.4217 -9.1514 -8.95746 6.26441 +4932 6 15.7983 1.14885 24.4111 -6.64534 16.957 -16.446 +4933 4 15.3695 0.397874 24.8496 -11.2605 5.13601 -9.62176 +4934 4 15.1572 1.72115 23.8957 14.1067 -25.56 23.4483 +4935 6 34.5718 39.7067 40.0668 -5.06722 14.7699 1.92827 +4936 4 34.1159 40.1215 40.7935 -0.0189783 27.8984 7.01187 +4937 4 34.2456 38.8495 40.221 -5.22714 -44.7262 -10.8544 +4938 6 20.1936 32.176 34.4055 -22.5016 27.7868 41.3602 +4939 4 19.6673 32.7687 35.0502 14.2298 -29.0143 -30.198 +4940 4 21.0584 32.1328 34.8407 -2.28869 -2.39527 -4.5293 +4941 6 19.3074 38.5208 11.8317 17.689 14.4135 -2.63233 +4942 4 19.236 37.5914 12.0232 -0.177798 -10.0936 4.99209 +4943 4 20.0172 38.8749 12.4245 -13.7536 -7.85063 -8.99287 +4944 6 6.52955 13.5023 26.836 -16.6143 37.6784 -17.6139 +4945 4 6.084 14.0762 26.1427 18.8957 -21.2062 24.9102 +4946 4 6.49663 12.6281 26.4634 0.197125 -15.4908 -4.14034 +4947 6 23.5952 31.5638 33.3318 1.16311 -12.5666 -5.83621 +4948 4 23.0836 31.562 34.1475 0.610672 3.97154 0.891929 +4949 4 23.5328 30.6432 33.0053 1.46337 8.27478 -1.79938 +4950 6 41.0778 31.9114 16.1974 16.3032 -14.6541 -18.8682 +4951 4 41.8878 32.072 16.7344 -12.1593 -9.44827 -16.6375 +4952 4 41.2894 31.3264 15.4036 6.53327 16.9697 25.199 +4953 6 31.7476 18.8699 19.3483 9.2825 22.1595 5.37598 +4954 4 32.0642 19.7361 19.7036 -9.20895 -19.367 -8.68372 +4955 4 31.4026 18.3831 20.1168 1.10858 -0.37958 -4.48043 +4956 6 10.4875 4.12209 19.3444 6.70816 11.4672 -10.0773 +4957 4 9.70261 4.48263 18.8666 20.7562 -4.21822 -0.723312 +4958 4 11.3166 4.33216 18.8218 -27.5212 -3.06207 15.0001 +4959 6 1.37991 32.4635 19.2846 24.7257 -29.6508 -15.3303 +4960 4 1.97113 31.6954 19.1311 -3.90248 7.07021 19.3035 +4961 4 1.16609 32.6455 18.3731 -9.24935 13.5936 -9.63824 +4962 6 42.8716 16.8513 24.9892 37.8526 -21.8211 -51.5646 +4963 4 42.4398 17.6894 25.0051 -12.6784 17.6471 3.13223 +4964 4 43.4179 16.871 24.1222 -26.4831 0.994324 39.976 +4965 6 45.3183 19.1979 4.10041 6.37956 15.045 3.35342 +4966 4 46.1127 19.7887 4.04575 -15.2131 -7.48775 2.85843 +4967 4 44.6191 19.6898 4.58798 10.0124 -1.75765 -5.61527 +4968 6 29.1291 19.8804 35.7574 13.154 -41.1853 -12.3735 +4969 4 28.6049 20.2559 36.4387 -19.4183 16.2678 16.1743 +4970 4 29.3151 20.5439 35.0927 -1.78114 11.3903 -2.63997 +4971 6 31.9353 21.8377 19.6787 8.2762 14.7684 -3.54893 +4972 4 32.7301 21.8918 19.0885 -22.5823 -4.29925 15.9785 +4973 4 31.6692 22.7774 19.8195 3.83825 -20.8185 -1.08359 +4974 6 39.1936 8.26228 18.8336 -23.7578 16.4079 -2.4793 +4975 4 38.9784 7.343 18.63 -1.41923 -3.63173 -0.882922 +4976 4 38.3593 8.77699 18.6285 24.7505 -17.6369 4.60834 +4977 6 33.27 13.2649 41.2621 -10.1289 -28.0457 11.6457 +4978 4 32.3532 13.5818 41.1472 2.43324 -1.71459 -0.314725 +4979 4 33.2053 12.355 41.6729 1.3348 20.3333 -9.56947 +4980 6 5.93721 29.5458 35.7995 -7.4397 -15.3695 -5.23966 +4981 4 6.3797 30.3135 36.1022 6.42857 23.5026 12.0451 +4982 4 6.51225 29.246 35.0987 1.02237 -6.8727 -9.18458 +4983 6 13.023 34.1764 31.9266 -10.1581 -4.84889 27.419 +4984 4 13.003 33.3874 31.3637 -4.82745 -5.23795 6.11925 +4985 4 12.6053 33.9771 32.8123 10.4055 -1.49763 -26.3146 +4986 6 33.9757 21.8032 17.9969 16.1152 -19.1834 -4.43927 +4987 4 34.6651 21.0941 18.0436 -13.0194 10.1005 -1.31384 +4988 4 34.4424 22.6001 17.7557 11.611 10.6919 -5.33679 +4989 6 35.9777 41.3398 18.1614 -6.56463 -6.11943 -26.9477 +4990 4 35.8856 41.423 17.1648 6.35377 -3.40276 32.4743 +4991 4 36.5823 0.128109 18.4064 3.22136 6.47441 1.04719 +4992 6 34.856 37.6452 30.5972 -0.647303 3.94572 7.36538 +4993 4 35.2577 36.9607 30.0196 0.445186 1.06156 15.4535 +4994 4 34.8848 37.3986 31.5588 5.49281 -5.52744 -23.9922 +4995 6 25.9972 34.4216 4.68589 -10.7784 -9.94602 -21.2075 +4996 4 25.3582 34.53 5.39473 2.66172 5.48603 12.8385 +4997 4 26.8259 34.8497 4.89674 4.47855 8.12742 13.9663 +4998 6 19.0606 33.5662 1.31783 4.31184 23.0948 -29.5486 +4999 4 19.7493 33.0549 1.74461 7.17592 -5.61608 3.87291 +5000 4 19.5019 34.1007 0.592753 -8.94353 -18.7796 23.9626 +5001 6 25.2721 8.22916 8.60038 8.3672 -6.50911 13.4278 +5002 4 25.4774 8.1828 9.55838 -2.37789 7.03817 -10.0574 +5003 4 25.4001 9.14285 8.30246 -0.229164 -0.61302 1.82749 +5004 6 12.8408 19.6874 13.0432 23.1779 -10.767 -3.57874 +5005 4 11.9236 19.9359 13.0109 -16.1394 8.08564 -1.3752 +5006 4 13.3549 20.4875 12.8299 -11.6819 -5.55115 1.76181 +5007 6 53.3458 11.4322 5.81729 13.7919 -26.0181 10.511 +5008 4 53.941 11.999 6.3288 -5.2171 7.54934 -1.97002 +5009 4 52.6156 11.905 5.44666 -11.025 16.6744 -4.72885 +5010 6 9.84401 16.0447 31.1965 1.52473 25.7097 1.4485 +5011 4 9.0725 15.75 30.7245 -12.2986 -10.5074 -10.4763 +5012 4 9.76401 17.0228 31.1974 4.09395 -10.8484 3.46066 +5013 6 25.4337 20.2897 3.31222 -0.0744965 -16.6885 15.2888 +5014 4 25.4502 20.7681 4.1742 1.29774 3.58896 -22.0188 +5015 4 25.617 20.9088 2.59036 0.892976 4.59184 10.0233 +5016 6 20.7687 8.19442 15.6442 -13.8219 -45.5838 -0.24202 +5017 4 20.3131 8.5145 16.4113 -6.16339 18.6345 13.1662 +5018 4 20.3525 7.29833 15.5772 17.5129 18.5489 -8.91575 +5019 6 37.6537 8.61162 9.99803 6.38032 -10.5281 17.8344 +5020 4 37.9174 7.70722 10.2264 -2.01487 8.44182 4.78342 +5021 4 37.3414 8.51532 9.10193 -3.86116 3.7435 -6.65528 +5022 6 50.6588 4.51187 24.2729 -10.1552 -3.70856 6.87258 +5023 4 49.9071 3.88527 24.1971 13.583 4.61791 0.248303 +5024 4 51.4381 4.036 24.5943 -3.42543 -3.47462 2.6777 +5025 6 20.1632 24.8244 34.8962 -12.0105 28.899 -22.2545 +5026 4 19.9486 25.4522 34.1467 5.29317 -18.0262 19.0072 +5027 4 20.331 23.9626 34.5117 -0.31696 -10.3492 -2.27521 +5028 6 30.5785 22.522 11.2467 -2.76969 13.8933 23.9619 +5029 4 31.2526 22.1243 10.7257 13.2932 -13.8734 -17.1472 +5030 4 31.019 23.338 11.5119 -11.6942 5.7798 2.38886 +5031 6 17.322 40.803 8.03266 14.2969 -15.2802 9.14469 +5032 4 17.3696 39.9923 8.55945 -20.3131 5.85274 7.92005 +5033 4 18.1352 40.6655 7.5489 4.4024 9.10004 -19.1526 +5034 6 23.9661 41.0457 26.0803 21.1205 -0.428792 10.5169 +5035 4 24.3123 40.6207 25.2948 17.4674 -5.32369 -4.96192 +5036 4 23.0464 41.0448 25.8953 -36.0489 4.67224 4.09659 +5037 6 9.79449 25.5813 27.216 11.7002 -20.4303 -20.1428 +5038 4 10.1564 25.0129 26.491 -8.57195 17.3601 17.171 +5039 4 10.1924 25.2359 28.0288 -3.53182 0.239058 0.558234 +5040 6 35.2535 29.8267 24.7533 16.8399 6.514 6.92542 +5041 4 34.3962 29.6585 24.3475 -6.29365 6.70405 -5.90439 +5042 4 35.51 30.7547 24.57 -10.2352 -8.20594 -2.77553 +5043 6 2.14051 4.25227 10.5512 -4.35014 2.09559 7.87868 +5044 4 1.87018 4.24401 11.51 4.03105 2.56783 -22.6964 +5045 4 1.48695 4.75313 10.0317 0.0426026 -1.98947 12.7879 +5046 6 43.1755 3.92129 23.5016 -16.6861 -14.9885 0.818311 +5047 4 43.8939 4.14262 22.9078 7.68421 2.83398 -7.81803 +5048 4 42.5577 3.34913 22.9937 11.3891 7.34243 2.48813 +5049 6 18.8996 22.6297 2.43765 22.7339 -13.1014 -2.24121 +5050 4 19.79 22.181 2.40524 -25.7911 11.1615 4.63986 +5051 4 18.7139 22.8085 3.37028 4.18935 -2.21949 -1.21374 +5052 6 20.4908 18.9405 41.5599 0.284845 -17.4141 21.8797 +5053 4 20.1374 18.6064 0.533469 2.69626 22.1818 -33.2143 +5054 4 19.9839 19.6587 41.147 -4.56676 -6.01516 12.1125 +5055 6 26.4163 7.55623 29.1338 1.47231 -3.25042 -11.8229 +5056 4 25.7099 7.08251 28.6481 8.40182 7.03804 13.9135 +5057 4 27.0821 7.71224 28.4448 -4.02075 -2.1597 11.7889 +5058 6 25.6465 35.5679 33.7595 -11.9902 -19.4032 2.16293 +5059 4 26.3374 36.2384 33.6103 2.60319 -14.9989 -6.30077 +5060 4 25.8315 34.6987 33.2841 2.54327 33.8846 12.2934 +5061 6 24.8333 0.493635 8.41989 34.5336 11.5552 47.2955 +5062 4 25.5249 0.302877 9.1499 -35.8013 6.01564 -39.2036 +5063 4 24.7614 41.6068 7.91956 0.436288 -16.6888 -13.1367 +5064 6 17.008 17.3182 3.45493 -26.2706 15.7324 15.4846 +5065 4 16.2426 17.9829 3.53843 29.8189 -30.5055 4.13684 +5066 4 17.1653 16.9244 4.35506 -11.2277 16.1793 -19.3505 +5067 6 40.1827 32.1035 19.3506 13.0539 -5.95213 0.358733 +5068 4 39.8335 31.2604 19.604 -25.4023 -11.2285 12.0125 +5069 4 40.9513 31.7409 18.9215 18.5667 14.352 -9.19942 +5070 6 23.3808 26.7171 6.31746 29.0762 21.4976 14.3842 +5071 4 24.13 27.3908 6.46801 -30.1018 -19.5893 -7.69607 +5072 4 22.7349 27.0723 5.68536 3.11778 6.18165 -0.6273 +5073 6 28.6527 28.5112 1.41186 -10.6623 -30.4119 4.69741 +5074 4 28.683 29.4458 1.20631 15.125 4.74584 -7.70298 +5075 4 29.5288 28.0803 1.2704 -12.115 26.7011 1.44139 +5076 6 12.0438 6.3157 14.0384 -8.70244 -3.06108 -4.52058 +5077 4 11.2798 6.1721 13.4181 27.4537 -0.215786 8.28745 +5078 4 12.8925 6.19521 13.5554 -16.057 2.9292 1.41242 +5079 6 20.1243 33.7022 32.0954 -30.4257 7.53408 -8.19993 +5080 4 20.1371 33.1054 32.8412 7.6416 -5.80656 10.7415 +5081 4 21.0197 33.8732 31.8382 18.9224 -1.8204 -0.321518 +5082 6 12.0625 33.3632 34.5388 -0.325915 -41.4281 -23.9157 +5083 4 11.5602 33.8727 35.1697 -10.674 0.646784 10.687 +5084 4 11.6234 32.4653 34.3673 14.5179 34.5198 8.14895 +5085 6 6.00279 22.2605 25.0501 2.06163 -11.5991 79.3474 +5086 4 5.88194 22.3996 24.153 -16.4068 14.8809 -57.8418 +5087 4 5.25089 22.6367 25.5854 16.5977 -6.05374 -22.2773 +5088 6 28.8802 9.48792 11.0269 30.0757 -27.8021 5.60101 +5089 4 29.142 10.167 11.6644 -15.2392 1.2069 -12.766 +5090 4 28.0854 9.70897 10.5587 -15.7703 15.13 -3.00542 +5091 6 25.9783 31.1564 24.8742 0.212243 -23.2246 11.0271 +5092 4 26.2703 31.9474 24.4305 5.78101 9.73635 -10.8861 +5093 4 26.5948 30.4205 24.6499 -9.08002 14.2421 1.82694 +5094 6 17.4069 22.6321 26.9528 -11.8732 29.0046 13.506 +5095 4 17.1509 23.4374 27.5137 11.798 -28.7792 -23.9739 +5096 4 17.5283 21.9112 27.5803 0.671776 -8.09241 2.21186 +5097 6 30.9731 17.6144 1.64569 13.582 26.8251 31.1357 +5098 4 30.2123 17.6859 1.07719 -13.0538 -2.75682 -13.3747 +5099 4 31.0067 18.4528 2.19078 1.05257 -25.2161 -14.5596 +5100 6 35.2833 9.73343 11.2271 -16.277 -4.62114 -26.0747 +5101 4 34.627 9.45499 10.5137 29.3374 5.62349 25.4867 +5102 4 36.1567 9.37366 10.9701 -6.28276 0.375521 -3.01301 +5103 6 12.0057 10.8077 4.27601 -12.2512 -1.40581 -7.43609 +5104 4 11.4458 10.5898 5.05281 2.39288 0.24657 -15.6405 +5105 4 11.51 10.5288 3.46435 7.55978 2.35404 20.8087 +5106 6 52.9546 23.1284 7.66438 3.19212 11.9041 -9.13647 +5107 4 53.8155 23.0936 7.22037 1.72331 -6.21969 -0.472682 +5108 4 52.7997 24.0739 7.82392 -0.633169 -8.94194 3.43433 +5109 6 27.374 5.80114 23.1096 7.51778 12.7335 11.6917 +5110 4 28.1753 5.52132 23.6349 -22.415 18.9583 -13.4562 +5111 4 27.3645 6.79042 22.9959 5.3793 -33.2455 5.89418 +5112 6 22.7689 37.6996 15.5372 -5.91943 -7.67105 33.7333 +5113 4 22.8436 37.842 14.6084 2.14719 5.97904 -25.5056 +5114 4 23.2999 36.9284 15.7907 -0.822855 1.46565 -2.93441 +5115 6 30.5901 30.1355 39.7465 -8.92084 9.99629 -19.6672 +5116 4 30.0839 29.6315 39.0953 -1.54922 -9.94816 6.16305 +5117 4 30.5761 31.0154 39.3281 8.00114 -4.73058 9.29019 +5118 6 26.5152 14.8694 29.9646 3.93344 -0.205179 -3.29595 +5119 4 25.7559 15.3094 30.3103 -24.5604 12.1261 -1.41502 +5120 4 27.0839 14.9289 30.718 22.1413 -5.57177 12.178 +5121 6 9.52543 19.5487 37.4182 -4.93509 -3.75546 7.04348 +5122 4 8.56858 19.5373 37.6772 20.7537 10.8584 -9.00922 +5123 4 9.7741 20.4052 37.0166 -14.5013 -9.56436 9.93265 +5124 6 0.91928 14.8658 2.69601 -17.5095 9.99019 63.3715 +5125 4 1.47581 15.1737 2.02419 28.2707 8.36374 -43.6031 +5126 4 1.18821 15.4309 3.47389 -7.04008 -21.0896 -18.5042 +5127 6 46.427 27.1287 41.5945 43.2461 -1.33556 -25.8044 +5128 4 47.402 27.2052 41.2817 -46.4011 -2.64418 15.4668 +5129 4 46.0299 26.5803 40.8989 0.996959 5.24299 8.87294 +5130 6 47.678 23.0562 21.3872 5.44089 38.3346 6.01366 +5131 4 46.9403 23.2179 20.8133 -13.997 9.90145 -6.64011 +5132 4 47.7418 22.1285 21.385 8.56341 -43.7487 4.99103 +5133 6 39.8587 22.235 3.08723 2.37939 -15.5871 -9.21378 +5134 4 39.0088 22.2526 3.53641 -4.44104 7.43329 4.08383 +5135 4 39.9535 21.2857 2.86173 -0.917299 22.2801 6.61021 +5136 6 14.9853 14.9328 33.4647 9.90785 18.6887 5.96998 +5137 4 15.4024 15.8269 33.5858 -13.0369 -24.3412 -0.758701 +5138 4 14.5599 14.6915 34.3048 3.28451 6.61064 -6.43534 +5139 6 27.3302 11.4834 31.9317 -27.4366 -15.9755 21.8219 +5140 4 26.9982 12.0952 32.5883 -9.79098 -5.70708 8.51591 +5141 4 28.0752 11.9422 31.6406 46.9031 18.536 -28.2392 +5142 6 36.7579 7.97089 7.62034 -1.24967 -18.9477 -14.6485 +5143 4 35.954 7.42009 7.70022 6.4697 6.94413 -3.0671 +5144 4 37.4142 7.36122 7.22008 -3.07725 6.9494 1.66736 +5145 6 49.4451 9.66335 18.2174 -4.20907 -17.0946 -5.32386 +5146 4 50.1075 10.0642 17.6138 -11.2883 10.4151 20.0604 +5147 4 49.0937 10.2089 18.9473 16.8995 10.9543 -13.1485 +5148 6 27.0353 33.866 10.7555 -3.61813 20.4819 39.0174 +5149 4 27.1089 33.3944 9.9425 -11.0368 -7.55411 -28.9907 +5150 4 26.1735 34.332 10.8422 4.28798 -12.7598 -13.2634 +5151 6 11.1949 37.4624 6.84871 0.36549 -16.8746 15.3404 +5152 4 10.8648 38.3395 6.66289 0.465253 11.7734 -2.90488 +5153 4 12.1583 37.5341 6.85599 1.64848 0.115814 -1.2743 +5154 6 19.2537 19.4156 21.9114 -15.7985 8.22585 33.6704 +5155 4 18.5515 19.3251 21.2863 -16.3583 -5.26309 -15.3133 +5156 4 20.0646 19.323 21.4355 25.7859 -3.53787 -14.4318 +5157 6 54.4972 2.91444 22.5674 41.6328 11.7794 25.4635 +5158 4 54.323 3.09449 21.6644 -16.7292 4.15243 -34.296 +5159 4 0.405558 3.31869 22.7045 -24.6299 -12.807 4.19326 +5160 6 45.0583 10.8549 24.2301 5.83399 20.0221 21.0618 +5161 4 44.4296 11.5751 24.1426 -7.03973 -3.51443 -9.4179 +5162 4 45.6095 11.2138 24.9523 4.1225 -19.1196 -10.3672 +5163 6 14.387 34.402 24.7643 -0.614961 -5.50567 -8.46915 +5164 4 14.802 35.2302 25.0278 -0.621724 2.17228 4.67692 +5165 4 14.8142 34.1913 23.9221 -0.527667 -3.77388 -2.27373 +5166 6 50.586 17.557 4.30707 17.1275 -18.9627 18.6811 +5167 4 51.3126 17.9927 4.759 8.45418 -3.82203 7.11351 +5168 4 50.1863 18.2804 3.88376 -26.598 27.5468 -24.7799 +5169 6 14.9317 33.3337 34.1113 -12.3404 20.8418 56.9019 +5170 4 15.0455 32.9404 33.2912 5.44957 -23.8922 -53.334 +5171 4 14.0148 33.1563 34.3942 8.12215 6.97131 -5.23034 +5172 6 20.8706 33.5768 38.9143 15.1188 7.04694 -15.6549 +5173 4 20.7999 34.008 39.7578 -2.44584 7.66125 17.1111 +5174 4 20.3826 32.7659 38.9944 -10.1095 -18.4284 -0.973943 +5175 6 7.78494 4.73961 26.7587 18.7098 -5.63937 13.378 +5176 4 7.2181 5.0845 27.4506 -5.7435 6.37459 2.19378 +5177 4 7.246 4.75931 25.9687 -5.82922 -1.99593 -5.70414 +5178 6 9.28281 21.4851 22.3014 51.087 14.0475 -25.6174 +5179 4 8.74732 21.9732 21.6886 -31.0609 5.1079 -5.58489 +5180 4 10.1706 21.7227 21.8793 -22.1752 -18.3044 28.8298 +5181 6 20.5441 38.2146 8.8638 -2.83914 11.917 26.817 +5182 4 20.3663 38.6401 9.7626 4.81036 -21.6973 -30.7816 +5183 4 20.4013 37.2533 8.94236 -1.07384 9.24152 7.62946 +5184 6 30.1053 39.0795 30.7451 -13.6764 41.2724 28.6819 +5185 4 30.3998 39.946 31.2193 -9.10868 -42.8123 -24.766 +5186 4 29.1169 39.0706 30.8728 28.3121 -0.882933 -5.94109 +5187 6 16.0486 22.0268 24.5039 34.2787 3.60452 0.906339 +5188 4 16.7735 22.0671 23.8432 -14.3833 -3.87047 -0.289875 +5189 4 16.5419 22.3002 25.3044 -14.2176 -3.36187 3.5873 +5190 6 5.74232 29.2062 14.4594 -18.34 10.8061 -32.1404 +5191 4 6.48422 28.7094 14.7814 11.5218 -3.49899 17.506 +5192 4 5.24211 29.6259 15.1721 5.10135 -5.91064 9.04276 +5193 6 28.0673 3.08827 25.2267 -6.08854 1.42804 12.0746 +5194 4 28.6661 3.71086 24.7756 -7.19123 -0.840207 10.3279 +5195 4 27.7106 3.5203 26.0449 13.0908 -0.523763 -20.3567 +5196 6 45.9319 29.2971 31.4223 -7.33073 21.7818 28.5056 +5197 4 45.7264 28.738 30.6765 -12.0419 -4.51403 -16.7723 +5198 4 45.1872 29.9464 31.611 20.2512 -24.9239 -13.0948 +5199 6 11.2178 22.8398 36.7928 3.83605 7.6889 -19.1741 +5200 4 10.7288 23.4227 36.1801 1.54849 -6.36416 6.79315 +5201 4 12.0227 22.5824 36.3 -5.92076 -0.954096 11.0422 +5202 6 18.9236 40.1387 39.9284 -8.72712 -15.4473 12.674 +5203 4 19.137 39.1923 39.9727 -1.01676 1.76774 -7.47997 +5204 4 18.926 40.4024 40.8597 -1.95632 5.76083 -1.10583 +5205 6 23.5567 26.0801 21.2876 -20.8354 -5.58511 20.4095 +5206 4 22.8283 26.6117 20.9473 7.44123 1.31497 -7.03875 +5207 4 23.1869 25.6705 22.0991 12.7429 3.57595 -14.6326 +5208 6 16.8309 5.38685 15.8596 17.5735 -24.6285 20.3591 +5209 4 16.4468 5.29371 14.9868 -10.6119 14.9975 -0.930521 +5210 4 16.6163 6.1995 16.3389 -7.69088 7.65746 -13.895 +5211 6 12.049 26.6129 14.9962 1.83385 5.07399 -16.0821 +5212 4 11.6864 25.936 15.5307 6.55853 -24.3886 27.1256 +5213 4 11.2609 26.839 14.5085 -0.894459 16.8406 -16.785 +5214 6 14.3334 41.4222 2.37421 26.0216 21.5484 -18.2857 +5215 4 13.7051 40.9662 2.90199 -22.7144 -12.1023 21.977 +5216 4 14.3738 0.426145 2.71152 -4.41702 -11.6567 2.07407 +5217 6 50.4009 35.8582 9.31454 24.1561 17.2373 -12.1424 +5218 4 50.8168 35.8748 8.42953 -10.1576 -5.67977 3.83986 +5219 4 50.8977 36.5714 9.7704 -11.7974 -14.2445 3.10197 +5220 6 11.3695 22.6672 26.8678 6.20997 3.92483 11.2558 +5221 4 12.2048 22.3333 26.5164 -4.88328 -1.76893 -0.685046 +5222 4 10.6892 22.391 26.2565 -8.40373 -4.36232 -8.95219 +5223 6 8.45148 34.5593 21.2814 -25.9919 -59.0281 13.1791 +5224 4 8.04792 35.0446 21.9998 -0.548909 12.0582 7.93151 +5225 4 8.02348 33.6171 21.3881 27.3669 48.26 -12.6189 +5226 6 9.41918 8.68911 24.4735 -32.1109 22.232 -11.1027 +5227 4 8.45415 8.80658 24.2608 22.5553 -3.45738 3.03744 +5228 4 9.54271 9.26889 25.2379 6.1219 4.18012 4.13063 +5229 6 32.6166 22.3351 34.507 3.90791 9.0503 -27.7323 +5230 4 32.5036 23.1955 34.0662 0.599489 -5.17288 -1.28756 +5231 4 32.8196 22.6091 35.3861 6.87298 3.84758 30.2519 +5232 6 26.7427 26.1702 7.11338 18.0622 8.0778 -11.4877 +5233 4 26.0574 25.7087 7.60312 -9.51312 -3.43645 7.19196 +5234 4 26.4504 27.0916 6.97179 -2.60416 -16.0173 4.37043 +5235 6 33.9976 11.9299 3.97475 -1.16308 1.75568 6.69865 +5236 4 33.7915 11.6388 4.87314 3.4696 4.99202 0.68255 +5237 4 33.8545 12.8906 3.99294 -0.306808 -3.71184 -1.40707 +5238 6 21.4819 20.9256 37.2108 -8.76322 20.972 13.918 +5239 4 22.36 21.3309 37.2026 5.25525 -6.97128 0.105034 +5240 4 21.5739 19.9858 37.0637 7.9716 -15.2147 -3.23728 +5241 6 18.467 41.0278 0.654954 -19.554 -29.5721 -12.8619 +5242 4 17.5024 41.1258 0.530294 8.77033 6.01734 2.0842 +5243 4 18.8042 41.8885 0.845086 4.40915 26.8371 2.49279 +5244 6 41.3548 41.7118 25.1844 12.9409 14.5374 -0.392323 +5245 4 40.9222 40.8883 25.4041 -6.90081 -12.2223 3.22908 +5246 4 41.5202 41.6634 24.2378 -1.56977 -0.361026 -1.444 +5247 6 27.6369 28.1312 3.93858 39.9773 31.9241 -60.8173 +5248 4 27.7577 28.1455 2.91253 -1.05119 3.80663 52.0412 +5249 4 26.945 27.5412 4.09124 -36.8498 -31.9254 8.70709 +5250 6 18.2839 10.5111 31.4966 0.533258 -0.0130678 0.979798 +5251 4 17.4029 10.1636 31.5665 -10.6602 -13.9647 -0.00296819 +5252 4 18.1106 11.4466 31.5267 10.9856 11.4938 1.12981 +5253 6 11.3036 37.9694 14.764 4.77413 -10.0896 11.5971 +5254 4 10.7874 37.239 14.4221 -9.53089 5.23111 -9.63971 +5255 4 11.7579 37.5414 15.5118 -2.30342 16.6377 -5.07599 +5256 6 0.816524 18.1414 27.5647 20.1272 -0.3628 -0.469578 +5257 4 0.17179 17.4415 27.469 -11.396 -5.37013 -1.78049 +5258 4 1.63281 17.6507 27.785 -7.45447 11.2502 -1.88757 +5259 6 36.8008 10.7378 20.295 8.4208 9.86458 8.47872 +5260 4 36.1948 10.0642 20.0001 -9.44027 -8.16387 -5.04241 +5261 4 36.5983 10.8279 21.2363 1.65531 0.40354 2.85938 +5262 6 47.4201 25.5213 8.04394 8.74054 5.57223 -13.14 +5263 4 47.3566 25.6372 7.0634 -2.71671 -4.96685 23.4826 +5264 4 46.5708 25.2582 8.40304 -6.39129 0.734124 -5.55138 +5265 6 13.9238 35.1275 16.0037 32.5083 18.1998 3.59786 +5266 4 13.2022 34.5755 16.1957 -32.489 -30.3694 18.6715 +5267 4 13.7597 35.4303 15.121 4.25156 9.41728 -20.5426 +5268 6 29.562 35.3734 16.1776 -35.0835 -2.07929 -8.00281 +5269 4 30.2224 34.9599 16.7245 13.9673 -5.91711 9.2078 +5270 4 28.7051 34.8863 16.2926 25.5199 12.926 -4.35301 +5271 6 29.4722 25.8866 32.4187 14.354 2.72026 -23.1845 +5272 4 28.9025 25.7608 33.1796 -14.4011 -9.23541 2.43376 +5273 4 29.1922 25.3818 31.6086 -3.9853 6.0929 23.1903 +5274 6 24.1343 2.13601 25.4438 45.8363 12.8335 -27.0328 +5275 4 24.6226 2.81425 24.8647 -23.4035 -21.9591 22.2831 +5276 4 24.7019 1.32842 25.3981 -18.0817 13.4017 1.18969 +5277 6 4.54354 34.4275 19.14 11.1292 -12.0398 21.377 +5278 4 4.4735 34.5954 18.1883 -15.738 1.03246 1.7136 +5279 4 3.71635 34.4131 19.6775 9.89222 2.06937 -18.6971 +5280 6 10.1248 17.2257 14.3121 -1.66581 -5.60367 -9.60454 +5281 4 10.2583 17.5937 15.1679 8.8306 2.43924 21.0325 +5282 4 9.4989 17.8227 13.9164 -6.75609 1.38519 -13.487 +5283 6 21.4392 41.7587 34.6855 22.2624 7.769 -11.2018 +5284 4 21.5032 41.1211 35.405 -13.4071 -7.19641 7.36579 +5285 4 20.544 -0.0182627 34.3462 -4.72666 -12.2957 11.4101 +5286 6 36.1543 24.108 12.5954 -4.82194 -9.49577 -8.67068 +5287 4 35.691 23.694 13.3698 5.25066 1.62288 -23.6525 +5288 4 35.776 23.8018 11.7194 2.97337 4.42231 26.8685 +5289 6 49.5838 18.601 19.9434 7.37368 0.836531 -4.03301 +5290 4 50.0063 19.3607 19.4891 -2.40205 -12.3461 5.19746 +5291 4 50.2865 17.9356 20.0577 -3.44895 8.52353 -2.14521 +5292 6 1.26001 7.05318 14.4907 38.3056 -26.8237 -27.7837 +5293 4 1.8201 6.82299 13.6677 -23.9217 11.4061 34.9177 +5294 4 1.48256 6.35829 15.148 -4.21477 12.5307 -9.57675 +5295 6 12.7431 22.7759 31.2417 -21.5742 -17.6245 -17.2109 +5296 4 12.7068 22.0167 30.6251 -0.189583 12.5272 11.0438 +5297 4 13.6543 23.0267 31.2833 20.8009 4.17698 1.04357 +5298 6 8.18693 18.6259 27.8062 12.2535 -2.56913 -7.18349 +5299 4 8.40416 17.6764 27.919 2.05523 15.8207 -2.89848 +5300 4 8.90605 19.0032 27.258 -7.77238 -10.2714 7.52916 +5301 6 52.132 28.0244 15.3085 -5.0475 -8.46487 8.97907 +5302 4 52.2845 27.4141 14.5747 1.7297 4.34316 -0.517396 +5303 4 52.1194 28.9169 14.9336 2.1814 -6.82244 -4.33507 +5304 6 52.6909 21.916 10.0977 -8.33066 3.09691 2.06611 +5305 4 53.4463 22.3007 10.5387 10.5159 5.84972 4.87058 +5306 4 52.7807 22.2562 9.19728 -3.40401 -0.944397 -1.81328 +5307 6 22.3502 5.78024 2.67711 -1.19821 4.70475 8.9403 +5308 4 22.3462 5.61537 3.63751 1.98719 -8.03511 -7.01348 +5309 4 22.5962 4.95479 2.25163 2.53332 -12.0932 -0.158426 +5310 6 15.4205 16.2192 21.8867 5.02822 24.0999 -40.4778 +5311 4 14.4784 16.2102 22.0595 -10.022 -3.20892 10.2198 +5312 4 15.4767 16.6809 20.9929 2.09736 -16.6333 30.6862 +5313 6 28.7089 41.2927 33.91 5.52796 3.54283 5.25404 +5314 4 28.727 40.4953 34.4564 -2.79359 -2.24742 -0.170863 +5315 4 27.7951 41.4466 33.6263 4.57527 -2.88437 3.84631 +5316 6 9.01739 31.2727 18.2059 -18.1749 -3.84142 11.7815 +5317 4 8.98151 32.2312 18.3694 0.025829 -3.44513 1.18933 +5318 4 8.52849 30.7949 18.9304 13.8496 11.5721 -17.6376 +5319 6 20.5529 20.3981 18.1799 -10.2473 -3.12886 -8.71499 +5320 4 21.0329 20.6151 18.9854 0.125323 4.65459 7.73128 +5321 4 19.8496 21.0773 18.075 13.4895 -10.4913 3.92819 +5322 6 53.9703 14.7072 37.8312 5.01214 -4.5628 8.74013 +5323 4 53.4666 15.4974 37.9319 -5.56379 24.6001 14.4542 +5324 4 53.6093 14.375 37.0321 1.20033 -18.5897 -21.23 +5325 6 28.9035 15.3885 18.8586 45.4636 -15.1916 -0.680493 +5326 4 29.8469 15.0873 18.5932 -41.6456 12.1347 6.71251 +5327 4 28.9115 15.3505 19.8299 -3.5302 1.25595 -2.12016 +5328 6 2.00256 25.8212 18.9096 3.72723 11.471 14.7099 +5329 4 2.26458 26.6216 18.4327 2.14682 1.88771 -0.892997 +5330 4 1.76414 25.179 18.2501 -5.23937 -11.562 -15.1322 +5331 6 53.2507 40.704 24.2965 8.91441 12.4597 1.37217 +5332 4 53.4683 39.7911 24.0958 -2.511 -10.6834 -0.444896 +5333 4 54.079 41.1598 24.0633 -8.96863 1.63956 3.52407 +5334 6 47.5231 32.0042 22.8531 -14.3462 4.46803 -6.08063 +5335 4 47.3408 32.7709 23.4273 6.00779 -4.56073 2.25025 +5336 4 48.2766 31.5253 23.2067 4.67997 4.39959 7.43042 +5337 6 24.6197 26.1463 33.0089 -12.4366 -5.18424 3.68853 +5338 4 24.4183 25.6868 33.835 -4.3875 -0.159577 -1.83724 +5339 4 25.4547 26.5812 33.1385 10.0429 5.3772 -3.83199 +5340 6 21.3442 17.0884 39.4824 -9.75867 4.42788 -12.86 +5341 4 22.0786 16.6105 39.8509 9.0034 -0.419098 8.66004 +5342 4 20.9617 17.649 40.1682 3.71874 -0.284678 5.70811 +5343 6 11.0324 40.4486 17.0358 15.7971 -30.8577 -26.0801 +5344 4 11.6842 41.1185 17.2103 4.65986 12.9737 2.4903 +5345 4 11.491 39.8695 16.3608 -26.1319 15.9634 25.4848 +5346 6 20.3416 21.2702 39.8615 -24.9835 10.9638 22.3655 +5347 4 20.689 20.9793 39.0389 13.9219 -9.37305 -28.7546 +5348 4 21.0638 21.2843 40.4958 4.25493 1.29328 -0.298347 +5349 6 2.11091 29.6941 22.5934 -5.9509 -23.8702 -11.6938 +5350 4 1.45034 28.9715 22.5035 1.67869 13.3355 3.97539 +5351 4 2.94117 29.2559 22.3631 0.0654014 9.01208 -1.60678 +5352 6 36.7558 30.2897 35.4506 24.3729 -18.3256 16.5828 +5353 4 36.1768 30.1398 36.2224 6.47664 5.98183 -7.75951 +5354 4 37.6324 29.8684 35.7011 -26.9845 14.5763 -5.36474 +5355 6 12.9471 4.31284 37.9204 -6.90268 -11.166 6.10722 +5356 4 12.3078 3.59731 38.1765 12.7034 25.1114 3.17689 +5357 4 12.7446 5.19856 38.3152 -2.40344 -19.0082 -2.01981 +5358 6 38.3332 5.26794 18.4655 -19.3496 19.9027 -29.1997 +5359 4 37.4721 5.17942 18.8804 2.72791 -1.29988 8.64573 +5360 4 39.0241 5.01488 19.0552 15.587 -10.1496 24.0772 +5361 6 10.4858 9.23289 21.7404 -25.2332 -4.10139 2.16313 +5362 4 10.1465 9.25623 22.657 12.6022 -3.18555 -3.91704 +5363 4 11.447 9.27854 21.7188 5.40032 0.87934 7.2107 +5364 6 0.505771 41.0407 17.3245 -0.427706 37.3637 0.906459 +5365 4 1.03474 40.3115 17.5973 10.8601 -24.0642 8.3812 +5366 4 1.07952 41.8285 17.484 -10.202 -14.0113 -5.73388 +5367 6 4.10283 5.07754 6.43738 -38.2782 -14.6693 -26.7901 +5368 4 4.80956 4.44559 6.48511 17.8781 -6.62955 4.00539 +5369 4 4.33824 5.81877 6.9517 16.1672 26.1823 21.8329 +5370 6 11.4353 25.4218 0.164599 -6.84764 4.42394 -1.26617 +5371 4 11.3082 26.3017 0.56247 4.23965 -3.25035 1.30302 +5372 4 12.32 25.1006 0.40702 -4.64442 7.63092 -0.276853 +5373 6 7.41885 21.5502 8.10769 10.495 -13.722 -26.2993 +5374 4 7.61759 21.2522 7.17802 -11.0567 9.56016 28.8323 +5375 4 8.26229 21.8826 8.44859 -7.90548 -1.09713 -4.6635 +5376 6 47.5869 16.3678 25.2584 -15.0789 15.5873 -32.807 +5377 4 46.6352 16.1327 25.0388 32.9447 8.00435 6.4503 +5378 4 47.9767 16.8704 24.4584 -11.2605 -20.3751 33.7323 +5379 6 30.9209 19.4939 39.8451 -11.8548 28.7526 -24.1689 +5380 4 31.8555 19.5183 40.0202 17.1254 -10.6903 10.4692 +5381 4 30.8076 20.3562 39.3598 -8.87252 -26.4956 11.5622 +5382 6 20.3775 24.0331 39.393 16.2123 32.2964 -6.62361 +5383 4 19.46 24.2872 39.3788 -17.3162 -0.971439 2.40317 +5384 4 20.4139 23.0995 39.5119 -7.32592 -29.4126 2.4841 +5385 6 45.906 21.2665 41.1719 -24.2736 -11.4825 -0.885762 +5386 4 46.5804 21.1569 41.8486 15.7955 10.6383 -1.5802 +5387 4 46.0859 21.9477 40.5132 15.7742 6.36757 6.57249 +5388 6 32.5682 28.1996 30.46 3.6658 -10.99 6.0107 +5389 4 32.938 27.299 30.6104 -6.7941 21.8776 -2.09353 +5390 4 33.2105 28.8285 30.8344 -2.85996 -8.65293 -4.24176 +5391 6 18.0144 1.30598 27.0418 -16.6632 -1.71712 -0.445992 +5392 4 17.1007 1.69106 27.0468 26.0213 -5.17059 4.63351 +5393 4 18.4653 1.60291 27.8546 -9.34219 2.14994 -8.02835 +5394 6 39.3706 24.9704 21.8707 -3.8719 -7.6304 -3.05608 +5395 4 39.4638 25.9303 22.0078 -2.06007 -5.24545 2.56571 +5396 4 38.5004 24.7369 22.2528 8.08795 9.92494 -4.1564 +5397 6 33.5838 21.3134 22.0984 8.18441 -4.13225 6.82001 +5398 4 32.7138 21.3502 21.682 2.4933 6.37883 -5.99313 +5399 4 34.1113 22.092 21.8324 -12.1677 -4.37971 -1.53996 +5400 6 40.113 14.9986 15.7558 -14.3933 -54.3129 -47.4443 +5401 4 39.335 14.6192 15.2293 31.4969 18.6384 20.9479 +5402 4 39.7901 15.7154 16.2477 -17.7573 36.9578 24.811 +5403 6 32.6916 17.9228 6.36161 -9.89813 9.73379 -21.0853 +5404 4 32.6423 17.3002 7.0662 1.70901 -17.6566 26.5232 +5405 4 32.2464 17.4542 5.63975 -0.790726 3.03073 -5.51736 +5406 6 50.4678 15.9334 31.144 -39.7004 -26.5385 31.9374 +5407 4 51.253 16.1743 30.7093 39.9028 11.8107 -24.2063 +5408 4 50.5343 14.9829 31.3801 -1.18751 16.0768 -7.78774 +5409 6 23.825 29.3336 31.6412 17.8706 -6.79638 -8.14744 +5410 4 23.7507 29.695 30.7549 -4.03414 2.57591 0.878238 +5411 4 24.7016 28.8907 31.6365 -14.4802 6.46497 6.02506 +5412 6 25.0497 41.6479 38.28 3.49637 2.98657 -6.73496 +5413 4 25.6848 41.2957 37.6072 -14.3525 10.6226 12.6055 +5414 4 24.5759 0.544247 37.957 10.7828 -14.7666 -1.7986 +5415 6 14.3338 25.4719 8.00129 -34.0608 -17.9542 9.33499 +5416 4 15.0375 25.807 7.49197 32.7442 17.1809 -19.3974 +5417 4 13.7504 25.049 7.33286 9.67269 6.09785 11.4563 +5418 6 17.2157 20.7463 5.33337 -33.6161 12.1619 46.6806 +5419 4 17.4746 20.2104 4.61987 19.6997 -12.8632 -39.6831 +5420 4 17.6039 21.6267 5.33982 9.69266 2.06371 -12.0346 +5421 6 18.8632 10.9532 23.7128 -6.45661 -28.7698 -18.1749 +5422 4 18.5024 10.4645 22.9505 4.54871 -4.25462 9.96764 +5423 4 18.7195 11.8343 23.4273 2.43458 32.1183 3.28403 +5424 6 7.79185 41.3929 11.0465 3.42517 6.73563 9.75028 +5425 4 8.03468 40.5075 11.3396 -5.29569 0.405018 -3.04036 +5426 4 8.54504 0.0288503 11.3371 -5.83581 0.184768 -2.76634 +5427 6 48.7029 23.1861 34.0656 -21.7207 -4.36764 -18.9996 +5428 4 48.0685 22.9631 33.3267 17.6914 7.49561 22.5851 +5429 4 49.5647 23.2306 33.645 9.38657 -0.0360042 -3.96825 +5430 6 53.7171 23.5593 15.3279 7.98903 18.1369 9.52531 +5431 4 53.9889 24.0987 14.5512 -16.5338 -16.4319 -0.0123194 +5432 4 53.1679 22.8017 15.1046 0.0193492 2.24596 -12.2178 +5433 6 22.2331 5.62812 9.84443 -1.57081 2.06392 2.32933 +5434 4 21.8309 4.81719 9.48029 9.17546 11.008 0.0652314 +5435 4 22.6135 6.1669 9.11622 -10.9942 -17.7486 8.8339 +5436 6 33.6597 8.39756 9.07438 12.888 -3.30103 7.28088 +5437 4 32.9598 8.97334 9.38893 -12.3292 7.33717 0.65351 +5438 4 33.4682 8.16911 8.16186 -5.09418 6.09353 -6.44604 +5439 6 47.3119 37.7194 20.3363 21.5156 22.744 3.03657 +5440 4 47.6473 37.5407 19.4464 -9.46862 -8.33692 4.35957 +5441 4 46.6883 37.0359 20.5464 -12.6113 -19.4741 -3.99141 +5442 6 30.8566 16.7294 10.6197 -45.1927 -36.7422 15.3603 +5443 4 30.4293 17.2093 11.3782 10.0419 -7.15869 -15.9692 +5444 4 30.3248 15.8445 10.5087 28.8517 44.18 3.4025 +5445 6 48.1145 27.7388 10.1259 3.61398 12.7601 13.975 +5446 4 49.0121 27.5791 10.4269 8.16567 7.74751 7.8449 +5447 4 47.9875 27.049 9.49259 -14.0608 -13.1923 -17.2023 +5448 6 27.3333 38.6223 25.6028 2.23096 -19.4823 3.9502 +5449 4 28.2552 38.3493 25.5855 1.31221 -11.4567 4.08925 +5450 4 27.4115 39.4856 25.2253 -6.51803 21.9055 -3.11379 +5451 6 33.3641 5.73966 21.4502 -17.8674 16.1521 -18.7045 +5452 4 32.7333 6.1391 20.8022 11.3762 -13.0233 18.1576 +5453 4 34.2053 6.04196 21.1266 17.0109 2.35293 -3.511 +5454 6 25.3113 5.14231 4.52483 0.627568 -0.448638 -4.7772 +5455 4 25.9311 5.01166 5.26368 -5.83567 -1.85096 0.781095 +5456 4 24.4169 4.85751 4.79359 12.9854 0.158453 3.02285 +5457 6 40.4761 35.641 19.148 -1.79116 -1.08437 4.96155 +5458 4 40.617 35.2798 20.0294 1.97887 -12.6912 2.42284 +5459 4 40.4316 36.5735 19.3404 -1.08207 12.5153 -8.94186 +5460 6 49.6577 30.6259 19.0198 10.1565 -2.14928 -32.2041 +5461 4 49.9169 29.8714 18.4657 1.24638 0.0316256 -4.24874 +5462 4 49.4705 30.2089 19.8368 -7.31172 -12.6811 36.7039 +5463 6 42.1447 28.3235 17.0346 32.2065 -21.7575 -5.76428 +5464 4 41.8825 28.1658 16.1189 -9.06503 7.62036 -2.3435 +5465 4 42.9622 27.7534 17.0825 -24.1402 18.2728 2.552 +5466 6 47.7039 24.5139 36.3396 16.4403 6.39896 -6.79461 +5467 4 46.9537 23.9582 36.5487 -4.01092 -10.0931 -4.11437 +5468 4 48.0889 24.2445 35.4833 -10.0455 -7.86437 4.89019 +5469 6 19.3463 26.9837 19.8062 -14.9609 -0.640093 12.1457 +5470 4 19.5138 26.0435 19.7544 7.81166 -12.6546 -12.1749 +5471 4 18.7209 27.0489 20.5386 2.91516 7.38851 -4.99075 +5472 6 47.0534 26.8134 37.524 14.5946 -27.4581 20.3182 +5473 4 46.5999 27.4025 36.9765 -27.9132 42.868 -22.1392 +5474 4 47.3287 26.1433 36.896 5.92816 -9.16339 3.59921 +5475 6 9.30604 24.6864 40.2824 32.5721 -4.72803 4.84631 +5476 4 9.7425 23.8424 39.9878 -14.1318 19.2209 8.44319 +5477 4 10.0514 25.1942 40.7028 -19.8613 -12.5192 -10.8686 +5478 6 14.4861 17.9115 14.2864 12.9549 -2.10551 -8.28408 +5479 4 13.7677 18.2592 13.7435 1.92348 1.2648 2.86628 +5480 4 15.2633 17.8567 13.6783 -18.4643 2.67645 15.1406 +5481 6 37.1346 38.6824 18.7128 7.24689 -5.58535 -9.53541 +5482 4 36.7159 39.5508 18.578 6.84706 -0.690413 -9.37485 +5483 4 37.7177 38.457 17.9456 -10.6272 10.0511 7.65618 +5484 6 11.4119 5.91281 21.4549 8.51563 -6.63227 17.2429 +5485 4 12.0074 5.45436 22.0841 -12.0343 5.82261 -11.8758 +5486 4 10.9825 5.24051 20.9122 -1.087 -4.70833 -2.40093 +5487 6 4.25375 30.708 16.2346 29.3973 -34.9884 0.269827 +5488 4 4.09384 31.4404 15.6668 -11.3131 25.7038 -10.6546 +5489 4 3.7498 30.7826 17.0293 -13.4231 7.50595 13.7704 +5490 6 17.6719 16.0027 27.067 -23.8279 -26.0778 -36.6424 +5491 4 17.4271 15.046 26.968 10.0078 22.1048 9.82572 +5492 4 17.2008 16.3672 26.2667 15.5193 1.39518 21.9495 +5493 6 36.5109 8.65039 40.4308 12.8187 7.82554 4.51092 +5494 4 36.6212 9.57953 40.6523 1.70353 1.63484 0.0365135 +5495 4 35.6422 8.38915 40.7323 -7.59123 -4.26386 -1.28756 +5496 6 13.6114 12.9582 3.02589 -9.62347 -2.84414 10.0553 +5497 4 13.2363 12.4097 3.76862 19.3807 16.1747 -17.4749 +5498 4 14.4444 13.4268 3.2396 -7.87441 -9.64772 8.81761 +5499 6 38.5595 20.1494 21.6232 12.4359 -2.6335 16.4863 +5500 4 39.2259 20.3435 20.9591 -1.48691 0.443177 -6.45697 +5501 4 37.7118 20.0829 21.2013 -17.1516 -4.14152 -12.2545 +5502 6 50.9933 10.2578 30.842 -13.0607 -20.693 1.71035 +5503 4 51.4592 11.0512 30.6346 13.219 20.5706 -0.472754 +5504 4 50.4501 10.1493 30.0523 -4.00654 -4.85851 -2.78428 +5505 6 16.2749 2.41767 41.3132 30.43 46.2693 -10.4997 +5506 4 15.891 1.63581 41.6436 -18.412 -43.9133 0.0464609 +5507 4 16.2795 2.47169 40.3396 -9.09423 -14.5759 6.47164 +5508 6 16.5834 4.98938 41.8776 -7.21709 18.0228 -35.1788 +5509 4 16.7462 5.00964 0.881122 10.2158 10.5242 44.5139 +5510 4 16.3516 4.0781 41.7536 -3.71457 -12.9135 -9.58407 +5511 6 38.2173 37.6461 20.9885 34.7311 9.53448 3.02785 +5512 4 38.1039 38.1836 20.1861 -3.89758 -6.06348 6.62032 +5513 4 39.1638 37.7895 21.271 -30.6928 -4.57838 -6.40603 +5514 6 27.3006 1.89931 15.7822 -29.9599 0.296682 7.03709 +5515 4 27.5073 1.31215 15.0574 1.93116 -3.76907 -9.96281 +5516 4 26.3073 1.90747 15.8082 23.9237 -0.0762349 1.33551 +5517 6 29.0265 12.4386 37.8107 0.525722 -10.271 3.33822 +5518 4 29.5022 13.2884 37.7591 0.646351 -6.15481 8.15455 +5519 4 29.2991 11.9227 38.6151 -0.523918 21.8031 -11.8471 +5520 6 46.0742 20.1649 18.9021 10.3528 7.89056 -10.7305 +5521 4 45.1842 20.5502 18.8696 3.90233 0.901411 -3.14496 +5522 4 46.6469 20.7119 18.3183 -8.66547 -7.99067 8.59505 +5523 6 2.04022 38.6829 18.5084 -2.98341 9.82285 -40.3455 +5524 4 2.90324 38.7749 18.9245 -0.612017 -3.29975 20.9344 +5525 4 1.3228 38.3823 19.0758 6.43327 -3.78011 20.6074 +5526 6 44.0503 24.9822 25.9794 4.67294 -4.59524 3.88497 +5527 4 44.3373 24.0607 26.0767 4.76241 4.2408 6.41339 +5528 4 43.5759 24.9717 25.1449 -4.92835 3.44315 -2.97359 +5529 6 5.98031 26.6293 4.53551 9.30387 5.64625 14.1271 +5530 4 6.57491 27.1353 5.14729 -11.3776 -17.0368 -12.135 +5531 4 6.21313 25.677 4.5841 -4.82905 19.4284 -2.02229 +5532 6 0.0924267 23.2133 10.9333 1.42961 0.53672 3.80218 +5533 4 0.717354 23.7388 10.4004 2.9288 -9.65077 10.1872 +5534 4 0.580921 22.6863 11.5989 -3.01683 9.30052 -9.37626 +5535 6 39.1222 20.6154 12.8741 28.3348 2.95161 0.461931 +5536 4 40.0468 20.8249 13.1753 -23.4009 -9.33487 -2.82098 +5537 4 38.9932 21.1408 12.0685 -0.0080483 -0.226832 2.68059 +5538 6 39.959 39.9495 18.871 8.01281 1.93571 -21.8826 +5539 4 39.6441 40.4313 18.0693 6.09748 -11.7745 18.4856 +5540 4 39.3412 40.1359 19.5607 -16.2687 5.42221 11.8382 +5541 6 49.288 23.0046 30.5128 21.2206 -9.75551 18.5897 +5542 4 49.5389 23.7528 30.0013 -1.98497 24.1116 -29.9204 +5543 4 49.9896 23.0569 31.1809 -5.40626 -11.587 6.30696 +5544 6 10.3545 2.34292 9.14765 -20.562 40.259 12.8074 +5545 4 10.1012 1.5797 8.68555 -3.02669 -36.876 -18.9145 +5546 4 9.58966 2.94108 8.9894 20.4134 -0.423974 9.05106 +5547 6 9.6115 40.9317 19.7379 12.0905 -27.6191 -4.08509 +5548 4 9.69139 40.7751 18.7589 3.32448 -0.840478 24.839 +5549 4 9.96472 40.0953 20.2033 -15.7711 32.9781 -27.126 +5550 6 29.2535 5.10379 17.4957 6.62295 15.7752 6.05206 +5551 4 28.9547 4.7998 16.6324 -1.76299 0.290572 -5.22762 +5552 4 29.5626 6.02275 17.3534 -3.29284 -14.1281 1.20249 +5553 6 27.0956 15.411 3.22262 8.43004 -47.4217 3.28637 +5554 4 27.2677 16.3043 3.38591 1.16524 52.1129 6.18754 +5555 4 27.741 14.9724 3.82188 -13.792 3.46242 -10.72 +5556 6 32.8341 39.3821 25.1177 -1.66938 -44.1854 21.376 +5557 4 32.6253 40.2767 24.9331 -7.27917 31.8978 1.68524 +5558 4 32.4689 39.1753 26.0219 6.68592 11.3878 -26.9617 +5559 6 34.9613 7.8883 31.2358 4.6626 36.0744 6.61898 +5560 4 34.1778 8.39814 31.5057 7.62156 3.23778 -2.6687 +5561 4 34.6431 7.01199 31.2355 -6.57887 -35.8668 -2.78431 +5562 6 6.13276 36.7597 26.1434 10.8988 16.6869 20.3463 +5563 4 6.63888 37.4372 26.6797 -12.2659 -21.448 -21.9021 +5564 4 6.61066 36.5785 25.3331 5.0666 0.722926 -2.43587 +5565 6 6.00975 25.8323 24.1014 -4.47961 0.932019 -2.36624 +5566 4 6.35352 25.3647 24.9068 -18.3984 14.8695 -13.0656 +5567 4 5.16189 26.3111 24.2876 18.65 -15.8322 7.58859 +5568 6 45.6302 24.3945 2.56021 19.8484 -5.54431 -0.0961329 +5569 4 46.4674 24.0527 2.19931 -2.34639 0.0383291 -2.49188 +5570 4 45.6784 24.1611 3.48508 -4.52597 -1.56916 11.2469 +5571 6 15.5147 11.7041 32.683 14.9804 20.126 19.7749 +5572 4 15.7333 12.537 33.1619 -4.31998 -20.325 -9.45866 +5573 4 14.9494 12.0119 31.9786 -9.0483 1.88099 -11.1618 +5574 6 46.4109 17.7015 37.4781 -27.0258 -32.7931 -28.9932 +5575 4 46.5427 17.8951 38.3867 3.19976 6.65122 29.0636 +5576 4 45.8763 16.8534 37.4192 15.4316 28.8096 -0.764517 +5577 6 39.7197 20.9143 18.534 -24.0731 20.2285 32.8184 +5578 4 40.3775 20.5463 17.9571 20.7324 -0.0260386 -6.5243 +5579 4 40.0771 21.5962 19.1648 -0.0511872 -19.8333 -22.8182 +5580 6 23.8035 28.041 36.6748 9.0016 14.1447 -6.24075 +5581 4 23.3139 27.2938 37.064 2.44252 16.2828 7.25552 +5582 4 23.789 28.845 37.2599 -7.88527 -27.7019 -2.97202 +5583 6 23.2344 0.634844 30.8976 -0.384503 -14.0448 -5.97485 +5584 4 23.3889 41.8653 31.5825 6.30765 2.44689 -9.38002 +5585 4 23.8441 0.49945 30.133 -8.72578 -2.57312 14.648 +5586 6 37.1436 6.89172 28.2858 -3.37167 6.44507 30.6351 +5587 4 36.8056 6.23733 28.9583 11.2574 17.9183 -21.3683 +5588 4 37.4325 7.68669 28.8192 -8.94015 -21.4647 -17.7418 +5589 6 3.23535 6.60909 12.3935 -1.87368 1.73448 8.36027 +5590 4 3.03832 6.9284 11.4867 8.20532 -9.84476 7.71099 +5591 4 3.52123 5.67427 12.3822 -6.77188 11.8795 -6.70084 +5592 6 12.6173 19.1518 31.1213 -5.69854 -18.2223 8.29425 +5593 4 12.5903 18.2248 31.5183 -0.203161 27.8336 -18.7857 +5594 4 12.2771 19.1425 30.2049 2.23067 -5.60852 14.6148 +5595 6 15.1884 38.3149 41.5578 -3.57026 -0.303434 0.776802 +5596 4 15.4085 38.7623 40.7331 -1.55695 3.41656 0.7558 +5597 4 16.0064 37.8692 41.7958 4.70682 -3.66196 2.37744 +5598 6 49.6308 33.3399 19.6427 -23.754 -26.2674 -4.71234 +5599 4 48.6425 33.4171 19.8493 35.7001 -9.4047 -10.4581 +5600 4 49.8006 32.395 19.3286 -9.63678 35.3831 11.1391 +5601 6 6.36026 2.78098 29.8944 3.74937 13.951 -9.77631 +5602 4 6.39713 3.75696 29.8119 -0.635871 -14.0149 2.80012 +5603 4 6.09114 2.63212 30.8044 -1.55083 -4.44243 9.60337 +5604 6 13.1715 31.7798 30.2783 -11.6407 3.9064 -21.9894 +5605 4 12.793 31.9725 29.3819 8.72012 -0.590438 18.6573 +5606 4 12.9685 30.8401 30.4245 2.82441 5.28785 4.26217 +5607 6 32.3245 32.246 24.8932 -0.334642 -17.4514 3.51608 +5608 4 32.5833 31.3985 24.4266 1.55373 29.7789 3.70352 +5609 4 32.7413 33.0821 24.5914 4.2936 -14.9539 -9.40787 +5610 6 41.9919 14.5701 37.4124 -31.8928 -38.2057 -11.1184 +5611 4 41.1925 13.9916 37.278 11.7187 28.3557 2.93562 +5612 4 42.6351 13.8531 37.4242 20.2579 6.94588 1.70752 +5613 6 11.8923 7.24234 27.6655 -13.1666 -25.4093 6.94854 +5614 4 11.7936 6.42612 28.2118 8.91213 18.8361 -2.40188 +5615 4 11.255 7.06027 26.9538 4.64331 9.73453 -0.841263 +5616 6 14.1973 37.538 6.88791 4.07782 -38.2298 -28.3639 +5617 4 14.4575 38.4426 6.80778 6.05638 30.4198 1.96843 +5618 4 14.5936 37.1092 6.07523 -12.6749 10.0326 27.426 +5619 6 14.2479 30.6948 36.0545 7.37408 36.4971 9.0133 +5620 4 14.3981 30.7629 35.1101 2.39159 -10.6067 -11.9788 +5621 4 14.1779 29.7876 36.2972 -1.09854 -35.7585 -0.14866 +5622 6 16.4334 33.6494 5.49228 -9.96541 -28.1856 -5.39099 +5623 4 16.7983 34.5397 5.45321 9.37649 -3.55324 -12.1003 +5624 4 16.7788 32.9912 4.81355 -0.655183 31.9156 12.6517 +5625 6 23.0317 17.1547 7.8473 13.6053 -0.132883 9.10362 +5626 4 22.1841 17.362 7.40272 9.91908 10.567 10.3381 +5627 4 23.4804 17.9296 8.30446 -24.7767 -19.3244 -18.4116 +5628 6 51.7425 20.8913 27.7088 32.6403 -5.30395 6.54704 +5629 4 51.4526 20.615 28.6066 9.31531 5.01366 -13.1678 +5630 4 52.7523 20.9899 27.7096 -40.0215 -4.95426 2.55021 +5631 6 2.19474 27.6072 28.8013 -23.9703 3.8216 12.4498 +5632 4 2.89306 28.2617 29.0045 8.22653 -14.998 -10.5048 +5633 4 2.42593 26.8662 28.2089 10.4722 10.3682 5.46115 +5634 6 17.2069 14.3387 7.70681 0.210359 -30.5014 22.2216 +5635 4 16.8342 14.1932 8.62484 13.2745 1.87397 -27.442 +5636 4 17.791 13.5503 7.49447 -17.8498 26.4292 5.4189 +5637 6 12.462 8.93964 14.7065 0.798528 8.71873 -6.67623 +5638 4 12.2438 7.98523 14.5568 11.6803 11.8078 17.0064 +5639 4 13.0577 9.12873 15.4809 -12.5262 -17.6243 -12.8578 +5640 6 42.4139 38.0579 9.76413 -20.5008 17.2265 16.0611 +5641 4 43.2035 37.8944 10.2554 20.3834 -6.45835 6.72371 +5642 4 41.8905 38.6035 10.3913 3.31942 -7.4886 -15.3201 +5643 6 51.8227 30.3513 28.272 -27.6927 -20.9124 31.2363 +5644 4 51.4089 31.1514 27.9711 0.163888 16.7369 -10.597 +5645 4 52.6546 30.2313 27.8441 24.1641 3.9866 -16.3823 +5646 6 0.181148 18.531 4.58976 -5.95747 22.8787 14.3331 +5647 4 0.30783 18.164 3.72574 1.94264 -10.8238 -19.8991 +5648 4 0.385506 17.861 5.23812 2.38695 -15.8688 4.81738 +5649 6 34.1492 0.61754 2.99129 -49.6439 4.42439 -16.0687 +5650 4 33.2398 0.938351 2.63038 43.5613 -10.8791 15.5023 +5651 4 34.8325 1.13587 2.566 3.67212 10.3309 -6.27046 +5652 6 49.171 17.2374 23.1529 12.6877 -22.0026 -17.2704 +5653 4 50.1002 17.5391 23.0823 -12.4494 -3.65532 2.68691 +5654 4 49.1558 16.3609 22.6932 2.16788 22.8154 9.36775 +5655 6 23.1488 6.5083 23.6124 -20.5997 37.6057 -45.0229 +5656 4 23.0491 7.12001 22.8007 18.1878 -21.95 27.0503 +5657 4 22.2316 6.45775 23.8939 -1.28085 -6.53623 13.7239 +5658 6 11.0806 24.0842 29.2705 -8.73998 -10.3514 -18.9502 +5659 4 11.2441 23.4599 28.5168 0.0150655 10.4905 16.9308 +5660 4 11.7296 23.9083 29.9561 7.87164 -2.5542 2.12029 +5661 6 36.5429 4.08242 21.672 0.786556 -8.94696 -15.3954 +5662 4 36.4501 4.49554 22.5359 -3.35109 8.47972 1.84417 +5663 4 36.356 4.76727 20.9996 1.47044 -5.20042 11.1851 +5664 6 31.3053 25.6355 24.591 -3.66138 3.71718 3.54675 +5665 4 31.1335 26.2845 25.3159 5.93159 -20.4343 -13.8963 +5666 4 32.0778 25.0682 24.8002 -7.66178 11.3294 7.22687 +5667 6 42.6065 23.0403 14.7613 -16.8309 4.03618 -45.3098 +5668 4 42.9655 23.4598 13.9577 -8.276 -4.36486 -1.00498 +5669 4 43.204 23.3098 15.4118 29.6291 10.3091 46.448 +5670 6 14.3159 11.6727 8.8813 -14.5655 -17.9373 -12.2817 +5671 4 13.3434 11.4421 8.85146 29.9821 6.96631 -2.22077 +5672 4 14.7728 10.9717 8.34565 -11.3371 15.3318 14.175 +5673 6 21.498 2.14139 3.39648 14.7702 -17.8734 -6.06988 +5674 4 22.405 2.21099 3.73647 -11.0312 3.8274 -0.37696 +5675 4 21.4855 1.24815 2.9799 -4.51333 14.3419 9.54204 +5676 6 22.4606 27.6741 39.0725 -9.38699 -8.57051 -12.0691 +5677 4 22.9487 28.2157 39.6788 9.87489 12.9386 7.45564 +5678 4 22.251 26.9021 39.5804 -3.7481 -10.0177 3.53978 +5679 6 37.2705 33.4961 30.0614 -4.9469 -17.1986 11.1636 +5680 4 36.5019 32.9393 30.3108 14.0133 8.69925 -1.52787 +5681 4 38.0636 33.0902 30.4641 -13.5236 2.40347 -6.71067 +5682 6 41.8394 20.8621 40.0097 -20.8091 -17.9415 -11.9484 +5683 4 40.8821 20.7467 40.2088 17.4772 5.45688 -4.89215 +5684 4 42.2425 21.2111 40.795 8.11745 4.61319 15.3924 +5685 6 10.0509 31.1054 22.2556 20.3961 -18.8014 17.2446 +5686 4 9.98499 30.8639 23.2007 -4.95143 3.66172 -13.3958 +5687 4 9.23459 31.4918 21.9926 -24.2979 8.76968 -3.95477 +5688 6 24.2243 35.3747 6.62617 -9.42531 -3.96828 -6.7527 +5689 4 23.2865 35.2144 6.56466 -9.91939 -6.68958 -24.4488 +5690 4 24.2401 35.6133 7.54088 22.4532 10.3619 17.5563 +5691 6 54.2249 13.3694 18.759 -24.737 -0.349871 -1.41807 +5692 4 53.5933 13.3703 18.006 15.3609 1.78219 9.05355 +5693 4 53.6566 13.499 19.5435 10.7967 -0.400371 -8.89572 +5694 6 12.4855 25.1013 17.4456 -6.57337 13.5018 5.68311 +5695 4 11.9686 25.7405 17.9864 9.67417 -13.0798 -6.23069 +5696 4 12.9177 24.4729 18.0482 -8.67745 6.31928 -4.55572 +5697 6 22.3956 33.969 18.8874 -5.8063 -1.6479 -7.81353 +5698 4 22.8035 34.4497 18.1359 -8.0332 -6.19684 5.18696 +5699 4 21.6693 33.408 18.5182 22.6878 13.045 2.20471 +5700 6 24.4435 12.9292 5.84415 8.74588 -19.8564 16.0901 +5701 4 24.6262 13.8512 5.99703 -0.326218 20.1414 -4.57271 +5702 4 23.8078 12.8376 5.13214 -2.90401 5.95194 -4.82348 +5703 6 13.3959 11.2335 28.6038 -6.74888 -5.61354 -5.54718 +5704 4 13.7674 10.4842 28.0847 -9.93712 8.82772 12.9583 +5705 4 12.6218 10.8864 29.0903 8.08376 -4.51111 -11.0518 +5706 6 20.9645 34.7015 21.139 -6.51648 1.45471 -0.425004 +5707 4 21.4543 35.0255 21.9119 2.52902 -3.67403 -7.94594 +5708 4 21.5071 34.7067 20.3201 -1.1119 -0.149268 16.7291 +5709 6 37.136 34.5081 26.161 6.62209 -8.97684 -22.2932 +5710 4 37.2438 34.333 25.2112 -5.73965 -6.14541 10.65 +5711 4 37.5173 35.375 26.2088 1.33918 12.2816 12.8311 +5712 6 49.3593 27.1123 23.4681 27.9614 -13.0657 2.71617 +5713 4 48.46 27.3383 23.3348 -38.0547 10.3981 -3.53627 +5714 4 49.5827 26.632 22.6632 1.14175 -6.15755 -6.01297 +5715 6 2.6463 41.7198 27.6524 7.3894 17.9878 -25.5957 +5716 4 2.49639 41.7504 26.6775 -8.79282 -10.4379 14.5056 +5717 4 3.38399 0.440368 27.7439 -10.0848 -7.80081 10.7778 +5718 6 28.2486 5.66281 0.851705 -28.2484 -11.3463 5.20358 +5719 4 29.1342 5.88017 0.643235 30.8656 11.4658 -5.99415 +5720 4 28.269 4.69693 0.891643 -4.88577 1.64465 1.4719 +5721 6 46.3319 19.9354 30.6504 10.2867 19.401 8.99033 +5722 4 46.9123 19.9353 29.8821 -3.84989 -4.07474 -6.11394 +5723 4 46.5975 20.7732 31.0971 -12.3274 -18.5124 -2.17733 +5724 6 3.63748 25.7835 21.5531 -13.3498 -8.40935 -29.3244 +5725 4 3.82697 24.8656 21.7578 10.5845 0.467441 11.0774 +5726 4 3.24958 25.6945 20.6565 5.98204 10.7305 11.6574 +5727 6 2.75525 19.0991 29.6309 -15.3907 3.66354 13.2976 +5728 4 3.52302 18.6052 29.9384 7.69741 -2.11378 -3.28897 +5729 4 2.98375 19.5594 28.8227 11.6258 3.58084 -5.99316 +5730 6 11.8998 35.7779 24.2574 -1.81403 7.91701 -5.71356 +5731 4 12.4147 34.9912 24.3376 10.7342 -20.9531 7.85436 +5732 4 12.5443 36.3811 23.8879 2.19538 16 -3.69366 +5733 6 52.3427 30.4062 14.294 22.5839 4.39347 1.37497 +5734 4 52.8745 31.0934 14.7488 -8.66891 -1.23278 -4.46489 +5735 4 51.4935 30.7804 14.0876 -13.5204 11.8147 1.32314 +5736 6 0.0822874 24.3672 32.1291 -8.34182 -9.5272 -6.40877 +5737 4 0.828194 24.8082 31.7001 -5.59692 5.0286 6.41936 +5738 4 -0.0482457 24.7479 33.0025 4.35174 8.79498 5.58774 +5739 6 31.4966 23.7292 38.8152 19.1094 38.0757 -4.99319 +5740 4 31.5999 23.5133 39.7508 -8.21927 -12.2318 -1.63758 +5741 4 30.9751 23.0699 38.3783 -13.0662 -23.7861 4.62116 +5742 6 52.1169 21.6052 3.50792 14.3711 -14.904 -13.5765 +5743 4 52.8807 21.6364 2.89306 -16.3122 -4.91238 6.22228 +5744 4 52.1257 22.4771 3.8768 -2.65107 18.1744 9.91254 +5745 6 31.7478 33.9414 11.5999 6.40399 -14.705 -7.35618 +5746 4 31.326 34.316 12.3745 -3.98661 3.76902 9.36008 +5747 4 32.1024 33.0666 11.8569 -5.74966 15.1553 -0.43871 +5748 6 7.04869 17.6722 16.6738 15.5169 9.78585 -46.6303 +5749 4 6.86408 17.1452 17.4554 -1.12856 -17.4359 1.80272 +5750 4 7.18951 17.0724 15.8577 -9.09698 16.5018 49.1326 +5751 6 51.856 41.8666 22.1892 3.84753 25.5265 -21.3427 +5752 4 52.3772 41.4924 22.8897 9.65371 -13.9556 16.5062 +5753 4 51.0512 41.3628 22.1522 -12.8828 -14.9996 6.2925 +5754 6 50.8708 9.92691 25.9357 -19.3562 -16.2947 3.52683 +5755 4 50.5833 10.1225 25.0455 -2.85771 2.39787 -5.58996 +5756 4 51.6551 10.4289 26.0882 17.2727 16.0662 4.10656 +5757 6 8.99927 39.8664 13.8488 -8.14038 -13.6283 -23.156 +5758 4 9.59929 39.3497 14.3885 6.06913 -3.61279 3.55219 +5759 4 8.79522 39.3067 13.0547 7.60199 16.2117 22.1745 +5760 6 40.7023 25.5302 0.148896 6.79038 -13.4508 8.01702 +5761 4 40.3789 25.4701 1.07476 14.4856 1.96217 -11.1718 +5762 4 41.6802 25.6099 0.149801 -17.1473 -2.90233 2.89792 +5763 6 46.6909 7.84537 22.8702 9.17253 9.27189 2.7581 +5764 4 46.223 7.4121 23.6122 6.69651 11.5962 -1.82232 +5765 4 47.0858 8.70418 23.1544 -10.5797 -14.2101 5.83025 +5766 6 21.013 12.9106 9.96683 -11.4772 33.9385 12.3935 +5767 4 21.4714 12.292 10.5062 17.1864 -22.5118 18.142 +5768 4 21.2487 12.7153 9.07972 8.38308 -10.8862 -30.7653 +5769 6 24.8549 0.515446 28.6008 5.68052 19.4063 -7.13145 +5770 4 24.6132 0.0822417 27.7678 -2.25298 -0.561161 -0.933523 +5771 4 24.9931 1.46483 28.3802 -3.69568 -16.6941 4.65055 +5772 6 9.93738 22.6806 8.27387 -17.0851 30.8612 6.83622 +5773 4 10.4469 21.9921 7.84938 5.97494 0.327216 -18.4105 +5774 4 9.65147 23.3826 7.61609 12.4321 -25.0338 8.46255 +5775 6 33.2759 9.25001 23.8237 4.47891 -44.2955 15.8461 +5776 4 33.2652 10.105 23.448 0.909732 36.8069 -18.0196 +5777 4 34.1325 8.84557 23.5962 -5.93924 6.51534 1.57833 +5778 6 47.795 20.3665 34.2866 5.36639 25.6433 -13.2606 +5779 4 47.2589 21.0165 33.753 7.81309 -27.8153 16.882 +5780 4 47.2984 19.5618 34.502 -10.2742 8.68957 -7.27829 +5781 6 7.49437 13.498 41.0843 -1.51987 -1.91843 -16.5508 +5782 4 7.4491 13.1887 40.147 4.71488 4.53153 18.247 +5783 4 8.31974 13.1617 41.4819 -4.68073 -1.19795 -7.02436 +5784 6 9.95832 23.5973 1.60681 5.21402 2.49741 5.68021 +5785 4 10.4402 24.1882 0.998507 -5.12041 -6.82862 1.89989 +5786 4 9.65493 22.8254 1.1174 1.14228 -2.219 -8.51506 +5787 6 27.3184 14.1623 11.3341 -13.0256 18.3326 19.191 +5788 4 27.0532 14.8043 10.6617 -0.288735 -3.87647 -1.15481 +5789 4 27.1082 14.6278 12.1878 10.7132 -11.7932 -20.1286 +5790 6 25.8363 31.783 17.8928 12.257 -31.4953 -8.75538 +5791 4 26.5912 31.2312 17.6268 -16.3657 -3.28218 2.7807 +5792 4 26.257 32.5845 18.0942 8.13437 40.9862 10.9181 +5793 6 28.5106 34.3419 0.227626 33.3873 17.7784 12.057 +5794 4 28.9852 33.8482 0.904042 3.3493 0.859906 2.37016 +5795 4 27.7339 33.8559 0.0766936 -35.6263 -19.3635 -8.63216 +5796 6 39.4752 27.6784 22.7097 42.3367 15.2059 -23.9811 +5797 4 38.5679 27.9307 22.8105 -22.3645 11.7157 0.32019 +5798 4 39.9498 28.4084 22.1978 -16.9125 -22.6846 16.1018 +5799 6 19.4034 35.5119 37.6428 33.5095 -11.1022 16.798 +5800 4 18.7953 34.9333 37.2031 -16.031 -7.23993 -11.3762 +5801 4 20.0399 34.8524 38.0282 -15.2165 20.9239 -9.15559 +5802 6 40.2577 30.223 10.7322 40.2352 -13.6393 -47.8395 +5803 4 40.0003 30.153 11.624 -20.3139 3.96126 40.955 +5804 4 39.7054 30.7997 10.2038 -14.6911 14.5022 3.62333 +5805 6 44.8252 28.467 36.0943 -27.9317 -39.6182 20.2271 +5806 4 44.1 27.9067 36.617 42.0807 42.9759 -26.5645 +5807 4 44.8315 29.4044 36.3472 -5.71594 -8.07431 0.279077 +5808 6 17.9328 13.9421 34.2756 -23.0398 37.6904 -16.8553 +5809 4 17.2847 14.658 34.0723 21.6532 -14.16 -3.36915 +5810 4 17.4769 13.4978 34.9742 -2.33669 -21.4636 20.9706 +5811 6 22.7722 11.8049 25.9053 18.1639 13.4769 -8.32772 +5812 4 22.5143 10.954 26.1764 -32.0329 -27.8082 11.3637 +5813 4 23.7113 11.6387 25.939 19.9678 17.8754 -6.33473 +5814 6 27.9844 31.9785 40.3628 4.4159 -7.73511 16.6787 +5815 4 28.3104 32.752 39.9101 2.36742 5.81951 -9.83175 +5816 4 27.6866 31.3262 39.7216 -3.89657 2.92736 -3.90823 +5817 6 29.7056 5.13899 29.6966 36.1554 -28.1732 -9.81385 +5818 4 29.3242 5.52633 30.4675 -11.5775 13.5815 21.5043 +5819 4 30.5867 4.74321 29.9895 -34.1051 15.4003 -14.984 +5820 6 3.10893 21.4798 2.76501 -7.99866 -19.5262 -7.43282 +5821 4 2.82658 22.3873 2.73831 -4.86294 14.1814 1.21532 +5822 4 2.47005 21.0041 2.20282 6.80672 4.92349 5.4824 +5823 6 13.6497 30.6638 39.7451 -45.1888 -1.5 -27.4221 +5824 4 14.5316 30.8766 39.996 26.4643 7.88404 -4.33129 +5825 4 13.4124 30.9677 38.8135 13.6057 -6.06521 34.9266 +5826 6 39.188 23.0895 28.2562 15.2318 22.185 -40.3341 +5827 4 39.2961 23.1894 27.2636 -4.5014 -1.37473 28.8386 +5828 4 38.6302 22.3345 28.3879 -14.2617 -17.3372 5.24228 +5829 6 16.9988 23.7489 0.769214 20.7079 -15.4466 5.05665 +5830 4 16.2107 23.4786 1.24898 -3.68938 2.33828 -2.20359 +5831 4 17.6949 23.1909 1.19915 -10.9726 17.7258 -9.6056 +5832 6 0.328251 33.6592 13.0294 5.05621 13.0457 -18.8804 +5833 4 55.0348 32.9975 13.677 0.78154 12.2617 9.8199 +5834 4 0.388277 34.5816 13.3997 -6.36603 -34.6234 2.68168 +5835 6 49.1005 40.6595 16.9496 -9.76098 4.73909 -13.8177 +5836 4 49.2151 40.9775 16.0207 -4.23419 -6.48803 14.4163 +5837 4 48.1506 40.7848 17.1408 8.79948 2.71791 -6.65809 +5838 6 52.1337 39.9918 15.1756 26.7545 10.0433 -2.50902 +5839 4 51.9708 40.0067 16.1202 -6.38877 -4.81519 5.40892 +5840 4 51.3465 39.7494 14.7166 -22.4824 -4.17003 -7.64187 +5841 6 29.052 37.1033 37.836 19.097 -0.968932 -4.5801 +5842 4 29.682 36.5364 38.3049 -8.87198 1.40853 -5.4338 +5843 4 28.3717 37.2982 38.474 -12.8547 4.6316 9.68073 +5844 6 4.87585 1.47991 27.5772 1.0193 4.57332 -1.4391 +5845 4 5.21258 1.06654 26.7686 1.92757 2.57678 7.5628 +5846 4 5.62617 1.67061 28.1638 -3.61661 -2.55781 -2.1886 +5847 6 43.5959 24.3463 30.211 -19.7182 -5.92862 14.3815 +5848 4 44.3514 23.9347 29.8066 13.2495 -10.0411 -7.84874 +5849 4 42.954 23.6392 30.3929 6.93549 5.0637 -4.64144 +5850 6 33.7524 3.52358 22.9355 4.65558 -3.45748 -24.1115 +5851 4 34.2253 2.7722 22.5212 -9.10678 14.6802 11.3369 +5852 4 33.6063 4.18077 22.2154 2.29559 -11.8514 17.7295 +5853 6 19.8909 13.4517 25.3922 5.25873 -5.74859 -7.9771 +5854 4 20.5096 14.0736 25.7535 5.66529 16.002 2.33546 +5855 4 19.9521 12.7313 26.0185 -3.34295 -15.2779 0.0169051 +5856 6 47.3737 23.1767 39.6212 -5.95621 11.0118 4.46955 +5857 4 47.7191 22.5265 39.0041 4.75348 -8.18234 -7.77672 +5858 4 47.7813 24.0201 39.3891 1.84918 -0.94156 0.213564 +5859 6 20.1771 18.6734 32.3906 -2.68035 -24.6067 18.319 +5860 4 19.7167 19.3347 31.8914 0.274713 15.8779 -14.5216 +5861 4 21.1289 18.7867 32.3383 1.39014 4.37005 -4.23212 +5862 6 0.462706 5.80795 25.6713 -7.84599 -7.21428 -45.242 +5863 4 0.323825 6.56383 25.0471 7.25451 -11.4554 20.6165 +5864 4 0.632949 6.14438 26.5418 1.37183 20.4375 17.7538 +5865 6 6.87393 19.55 31.9207 -32.7339 30.668 -22.5905 +5866 4 6.24577 19.9891 32.5577 15.6688 -11.8235 -17.9631 +5867 4 6.64633 19.9665 31.0139 13.7505 -20.7976 33.8805 +5868 6 6.72837 20.2799 38.5105 -3.64262 3.78431 -13.5507 +5869 4 5.92588 20.8248 38.5086 9.85336 -2.70512 -1.72466 +5870 4 6.83039 19.9897 39.4188 -3.49896 1.12624 1.5432 +5871 6 22.0356 25.927 12.2605 -11.8373 -4.76705 -8.63625 +5872 4 21.2326 25.5939 11.7351 40.6868 7.42656 16.975 +5873 4 22.8707 25.497 11.9923 -13.8486 -7.11072 -10.1952 +5874 6 39.3057 7.93299 2.64755 -0.118713 9.42534 0.0803503 +5875 4 39.6638 8.10481 3.53463 2.86319 -1.68774 -0.268253 +5876 4 39.5974 7.06378 2.35963 5.09861 -8.7519 2.38745 +5877 6 29.9647 22.0457 34.4057 2.14844 7.25734 -28.1517 +5878 4 30.9338 21.915 34.3365 -18.2911 3.03872 -0.832433 +5879 4 29.6238 22.2503 33.4865 4.56359 -4.84177 28.516 +5880 6 37.5951 16.2788 0.369586 8.64826 -19.3515 -0.400608 +5881 4 37.1939 15.3927 0.526929 9.97291 14.3398 -5.3998 +5882 4 38.4404 16.082 41.8172 -10.5319 -0.823814 4.55326 +5883 6 11.7218 13.8845 21.8896 14.7882 -39.2126 -46.5495 +5884 4 11.9305 13.3995 21.0267 -7.58848 27.5443 23.8472 +5885 4 11.7147 13.1405 22.4934 -2.11531 -1.20748 18.2217 +5886 6 33.352 10.9238 27.6262 4.19409 14.5082 -21.7958 +5887 4 32.741 11.5866 27.2704 3.79692 -6.80494 8.02232 +5888 4 34.0591 10.8732 26.9373 -11.2958 -2.76298 18.1193 +5889 6 30.9422 36.5217 10.1011 0.546516 -38.0529 -7.53065 +5890 4 31.037 36.4313 9.10316 -3.7795 -1.86296 33.6151 +5891 4 30.9555 35.5897 10.5034 1.2522 32.9448 -19.5962 +5892 6 45.5828 6.56917 25.2425 13.4794 -38.3135 -0.0969536 +5893 4 44.6735 6.51564 25.4913 -20.1668 12.9455 3.79285 +5894 4 45.8221 5.605 25.2656 2.31227 28.4662 -4.04899 +5895 6 9.53612 30.0233 12.041 13.8898 -20.9008 -19.4413 +5896 4 9.92894 30.5763 11.3437 -1.97905 0.820167 2.98642 +5897 4 9.13364 30.6129 12.6538 -15.721 17.9312 16.9413 +5898 6 53.0747 24.9738 1.38132 -1.86355 2.7084 19.7503 +5899 4 52.7154 24.2509 0.898374 -13.0694 -24.4059 -9.99565 +5900 4 53.2522 25.5795 0.686793 9.94881 23.634 -11.856 +5901 6 26.1984 24.7352 0.509304 -7.53082 -0.727442 -26.3589 +5902 4 25.609 24.783 41.6367 17.1237 -12.5609 6.929 +5903 4 25.7967 25.3842 1.06587 -1.32139 13.3231 25.2347 +5904 6 23.0109 2.41889 11.5345 -1.81733 -0.917938 -19.7561 +5905 4 22.156 2.16845 11.9124 1.98231 0.963836 1.10425 +5906 4 22.831 2.471 10.5696 1.38956 0.195961 11.1121 +5907 6 29.9165 12.8947 31.0013 41.0722 8.15666 -12.068 +5908 4 30.8272 12.8901 31.3843 -23.6061 -3.22469 3.62361 +5909 4 30.1671 13.0589 30.0659 -21.5099 -4.3955 11.2257 +5910 6 24.0423 16.1922 40.3682 -11.7161 -52.7791 -12.7633 +5911 4 23.7963 16.7427 41.0863 -4.03022 37.1909 22.8519 +5912 4 24.4513 16.6836 39.6566 3.29428 17.0417 2.56802 +5913 6 21.8759 29.9137 12.7377 16.7673 9.38207 5.68416 +5914 4 21.0615 29.603 12.3447 -12.732 2.54077 -5.12984 +5915 4 21.8572 30.8889 12.7388 -3.49843 -10.2696 0.0943897 +5916 6 45.2049 12.2865 6.6319 2.92472 30.2037 5.62675 +5917 4 45.4908 11.5347 6.14771 0.0808414 -27.1796 -10.0093 +5918 4 45.9331 12.9133 6.49804 -8.49251 3.31449 4.74769 +5919 6 7.58748 25.3948 38.035 37.4402 -5.69153 16.1754 +5920 4 8.20159 25.1941 37.2709 -20.479 6.14302 24.9331 +5921 4 8.13335 25.2556 38.8857 -20.6102 5.92378 -35.7711 +5922 6 46.1732 7.83303 16.6988 4.4841 14.5494 -17.535 +5923 4 46.5452 7.84101 15.8027 -9.24205 10.2202 -0.760543 +5924 4 46.6945 7.14485 17.0776 9.771 -19.5689 22.069 +5925 6 54.9675 12.85 7.71106 -14.5426 11.3809 9.40253 +5926 4 54.9732 13.8139 7.75484 8.59467 -0.566973 -8.90089 +5927 4 54.3786 12.658 8.45528 8.25441 -10.7611 -5.52346 +5928 6 26.93 39.6729 37.1759 35.4319 -17.0193 24.0328 +5929 4 27.7049 39.4447 36.6239 -16.3058 8.04164 -6.8945 +5930 4 27.2164 39.2553 38.0316 -23.1866 12.5553 -17.3208 +5931 6 27.0277 8.92497 38.0115 25.8258 -15.1538 -19.4143 +5932 4 26.3205 9.53863 38.1727 -14.2244 17.8778 -0.0983549 +5933 4 27.5327 9.26244 37.2322 -14.307 -2.33761 14.5508 +5934 6 8.04621 7.65921 29.9125 5.96085 -8.8046 12.0925 +5935 4 8.66182 7.92407 30.6202 -6.26406 -0.422529 -8.96361 +5936 4 7.80891 8.46925 29.4702 -0.676119 14.2 -7.80782 +5937 6 27.8751 27.8625 12.1001 -31.3933 22.4686 19.454 +5938 4 27.5095 28.719 12.4446 7.36494 -19.3603 -4.77408 +5939 4 28.6439 28.079 11.5991 25.5597 3.40516 -15.3306 +5940 6 23.5464 30.4867 38.1533 -1.61625 -6.62341 9.61758 +5941 4 24.0833 30.8354 38.8715 -5.37174 -4.61911 9.80189 +5942 4 23.9933 30.8636 37.4157 3.53805 3.96797 -22.0348 +5943 6 48.0805 24.2983 17.323 -13.282 16.609 -1.2587 +5944 4 47.4189 24.8263 17.8481 20.4082 -10.1323 -14.146 +5945 4 48.1392 24.7467 16.448 -1.93384 -6.90404 13.1726 +5946 6 38.5137 5.30503 40.3397 -7.95418 19.3032 15.6478 +5947 4 38.8605 4.51762 39.8919 14.9068 5.60332 0.485922 +5948 4 39.0782 6.12858 40.3573 -2.94219 -25.5867 -8.28862 +5949 6 31.2334 3.92786 33.7298 9.31662 9.08835 -13.8199 +5950 4 31.8178 4.24357 33.0198 -6.00608 1.6224 5.38661 +5951 4 31.5957 3.05883 33.9262 -1.57661 -10.2527 7.73336 +5952 6 41.2417 8.81323 38.1247 -0.484904 -12.0607 11.4744 +5953 4 40.9476 8.42023 38.9721 -0.376638 9.54125 -7.13918 +5954 4 41.2604 9.77162 38.2616 1.58028 -2.03482 4.89657 +5955 6 53.3602 29.1001 24.587 -11.0956 7.72569 2.80506 +5956 4 52.5731 28.5594 24.8544 13.5868 20.3826 -7.54714 +5957 4 53.0545 29.9696 24.221 1.09296 -21.6534 7.27768 +5958 6 54.9204 15.5334 40.7094 -9.73888 -15.8123 9.62316 +5959 4 54.8689 16.4143 40.4003 18.499 35.235 -15.9181 +5960 4 53.9936 15.418 40.9228 -4.36807 -19.1537 6.40504 +5961 6 46.4046 17.0769 31.8825 -4.88415 8.61979 -0.317809 +5962 4 46.5643 17.9902 31.5503 -4.54791 -14.0743 0.407713 +5963 4 45.6863 16.6828 31.3336 12.87 12.2001 8.08584 +5964 6 36.9136 25.0502 23.0508 4.56287 5.14957 -21.3849 +5965 4 37.1181 25.0639 23.9643 8.53293 7.7605 31.6671 +5966 4 36.2092 24.4176 22.9617 -10.0712 -5.98832 -5.36051 +5967 6 11.3786 4.43396 15.9309 9.37238 17.2608 -3.05203 +5968 4 11.3458 3.5794 15.4688 2.43716 9.1998 0.97888 +5969 4 11.7026 5.12247 15.2999 -5.70859 -16.4138 5.77914 +5970 6 12.7896 7.06818 19.4525 -2.66824 36.6483 10.7184 +5971 4 12.9865 6.29411 18.9417 0.495259 -24.323 -4.17525 +5972 4 12.2519 6.828 20.2299 7.04203 -8.59773 -13.3487 +5973 6 12.0617 33.6499 17.5439 8.15138 -13.8576 -23.5514 +5974 4 11.882 34.0654 18.3682 -11.1792 16.7137 24.4072 +5975 4 12.5902 32.8825 17.8108 -1.08307 -0.300652 -3.52071 +5976 6 10.2421 4.75805 2.56564 19.3085 -11.8452 1.86691 +5977 4 9.45693 4.42703 2.99801 -10.4664 -1.42643 2.59081 +5978 4 10.9264 4.04527 2.68225 -6.18235 16.1727 -3.70264 +5979 6 4.57251 36.8735 12.1563 3.74049 -23.6741 -21.1206 +5980 4 4.47996 37.7154 12.5491 -11.9533 34.2042 20.255 +5981 4 5.43811 36.9355 11.7449 0.921031 -10.3689 -0.351167 +5982 6 30.7412 35.3317 25.8213 -33.1423 -23.543 6.44877 +5983 4 31.2776 35.279 26.6136 10.5944 3.70967 -1.00248 +5984 4 29.9668 34.7615 26.0677 13.1622 11.7399 -12.7178 +5985 6 20.1808 7.16217 1.863 30.1084 16.4868 -11.867 +5986 4 20.9002 6.54767 2.16414 -16.0511 17.5979 -8.58506 +5987 4 20.6676 7.94845 1.45686 -14.4541 -29.1822 13.3394 +5988 6 21.7608 6.89709 28.9964 -11.5861 -1.80466 -8.03013 +5989 4 22.036 7.16072 29.8728 6.26891 1.69864 13.9065 +5990 4 22.5393 6.5849 28.5353 8.83449 0.101288 -1.59126 +5991 6 6.87368 37.1369 6.9386 0.0966708 26.3677 27.0276 +5992 4 7.29364 38.0249 6.81033 -7.58004 -19.2864 -7.26696 +5993 4 6.61926 37.1727 7.88431 1.83825 -7.02501 -19.6681 +5994 6 37.1919 18.383 16.2937 29.0289 34.5069 -53.2335 +5995 4 36.6258 18.6038 17.011 -19.1901 14.6481 22.2869 +5996 4 37.3395 19.2625 15.7718 -11.4936 -34.1346 27.3139 +5997 6 52.3871 25.4845 31.3088 43.0013 26.9533 24.6388 +5998 4 52.3889 26.4071 31.692 -12.9868 -26.5619 -15.078 +5999 4 53.3562 25.2868 31.368 -25.5563 -9.18093 -7.26498 +6000 6 3.9438 39.8542 16.3866 5.1752 -27.5036 1.27902 +6001 4 3.12325 39.6837 16.8533 -2.95342 6.97088 0.658243 +6002 4 4.2268 38.9387 16.1321 1.7457 31.291 -0.663648 +6003 6 26.0576 14.6358 18.3044 5.96149 26.4073 -5.45028 +6004 4 27.0205 14.6227 18.4365 -6.17521 2.0803 0.6884 +6005 4 25.8163 15.5963 18.2277 1.60591 -22.5499 1.70317 +6006 6 22.193 39.6312 23.63 -9.05536 -28.9999 9.83005 +6007 4 22.6639 40.3889 23.3083 10.2118 22.7493 1.36107 +6008 4 21.7625 39.8434 24.4837 8.53947 8.47814 -10.8223 +6009 6 5.99591 12.8758 22.3742 5.3436 -0.661706 -0.190442 +6010 4 6.14325 13.1833 21.4713 -0.679137 1.38292 -0.893953 +6011 4 6.87425 12.6139 22.6767 3.78948 -2.07704 1.05968 +6012 6 48.9338 28.1628 34.7078 -35.8712 26.2385 4.15493 +6013 4 48.201 27.5556 34.4701 19.6025 -0.265843 1.21851 +6014 4 49.8217 27.8183 34.7001 12.2446 -20.4038 -3.75147 +6015 6 7.76997 22.4407 33.2353 -5.03116 -11.9457 7.57841 +6016 4 8.01899 22.0009 34.0594 5.33952 7.11928 -2.86974 +6017 4 7.10669 21.8538 32.8613 -1.17853 4.26119 -2.40878 +6018 6 41.0955 39.6222 11.7091 10.6381 -27.5326 3.52715 +6019 4 40.5189 40.2602 11.288 0.0449404 21.7474 -0.525631 +6020 4 41.8612 39.9918 12.1934 -14.1016 15.1893 -9.59654 +6021 6 26.8828 37.915 39.359 -2.28209 0.567193 11.8658 +6022 4 27.0774 38.1179 40.3058 -8.7685 -4.90824 -13.677 +6023 4 25.9807 37.5277 39.3071 12.6176 5.79057 5.20946 +6024 6 16.8333 41.5427 16.7885 -17.5694 -7.84814 -1.75502 +6025 4 17.5277 0.148354 16.3589 5.69783 -2.62712 11.3029 +6026 4 16.9979 41.3393 17.726 8.37907 5.88226 -10.2657 +6027 6 19.018 8.99657 17.6669 -0.857073 -13.2853 32.8939 +6028 4 18.786 9.90902 17.9004 1.19423 -0.949069 -3.8378 +6029 4 19.1413 8.47286 18.5173 -2.13518 15.132 -32.6231 +6030 6 31.1034 24.3848 20.0884 -4.53251 11.7336 -2.81937 +6031 4 30.5766 24.6463 20.8643 6.13742 -4.20791 -6.36966 +6032 4 31.7352 25.0989 19.9557 0.422515 0.146513 0.562515 +6033 6 24.595 6.30881 27.6069 -9.90555 -11.0232 -14.6341 +6034 4 24.6965 6.6392 26.7007 0.89989 8.76246 8.56835 +6035 4 24.5083 5.35606 27.4824 0.344086 -1.65377 9.53776 +6036 6 11.6335 5.32908 8.21523 29.3959 14.5761 -12.3078 +6037 4 10.744 5.12885 8.4339 -32.4949 -9.42488 11.9016 +6038 4 11.5648 6.10082 7.62627 0.276207 -9.77668 5.48929 +6039 6 16.478 34.2375 17.2464 48.0037 -1.61779 7.84119 +6040 4 15.7306 34.6529 16.8034 2.48832 11.605 -8.49411 +6041 4 17.405 34.6677 17.061 -56.7063 -17.2336 2.19282 +6042 6 40.7477 40.4696 8.51561 8.11488 -8.65224 -15.2287 +6043 4 40.0224 40.6832 9.09702 -8.50867 2.70994 6.70857 +6044 4 40.4514 39.6579 8.0617 2.3787 8.8385 5.97324 +6045 6 42.7444 5.87231 14.2984 24.2128 7.61876 -1.56509 +6046 4 42.0757 5.96647 14.9632 -14.4615 -1.80987 8.42029 +6047 4 42.482 5.17586 13.6922 -11.2697 -3.69634 -0.0191913 +6048 6 14.3614 21.0573 6.06698 -40.3301 2.02826 20.3099 +6049 4 14.5082 21.6099 6.85229 1.25225 -5.13952 -5.68983 +6050 4 15.1941 20.9025 5.67555 35.2665 -1.55979 -15.977 +6051 6 16.3015 37.7733 18.121 -25.7671 9.10936 -15.4408 +6052 4 15.381 38.1761 18.2458 41.2545 -15.1679 7.93486 +6053 4 16.7788 37.6858 18.9587 -11.1023 5.71932 1.62274 +6054 6 40.7984 27.7161 27.1129 -11.0179 0.499807 -0.336913 +6055 4 41.4742 27.2927 27.66 5.56711 1.79851 -1.75817 +6056 4 41.2133 28.334 26.4954 6.67104 -1.0644 4.19578 +6057 6 44.9561 25.991 14.0487 25.7727 -16.7938 -19.0088 +6058 4 45.3739 25.1637 13.7108 -16.5098 12.8855 15.8726 +6059 4 45.5476 26.6442 13.6478 -7.0093 2.51014 3.36733 +6060 6 2.61494 33.9473 21.2474 -9.6198 2.06317 -4.83635 +6061 4 2.13704 34.7904 21.3802 4.44423 -7.12162 -0.559399 +6062 4 2.10703 33.4352 20.5879 2.52794 8.8644 7.26413 +6063 6 5.77575 4.45209 12.8318 1.03208 18.7287 8.08797 +6064 4 5.35339 3.69685 13.2518 -3.06112 -10.1665 -2.69945 +6065 4 5.8052 5.15326 13.507 0.887863 -7.02627 -5.52828 +6066 6 16.8649 5.92112 7.40874 19.9951 -5.29142 4.66315 +6067 4 16.4994 5.07825 7.12483 -4.58221 -9.71617 -5.56506 +6068 4 16.109 6.48147 7.52662 -16.4719 8.95214 3.19539 +6069 6 17.8298 38.4233 36.8534 9.258 40.3096 -0.310058 +6070 4 17.7926 39.4131 36.8935 -6.04129 -19.7424 1.84578 +6071 4 18.5177 38.2893 36.201 1.93535 -10.8086 -1.92368 +6072 6 43.3019 20.5959 5.44166 -6.9278 5.85438 -3.52603 +6073 4 43.1055 21.501 5.07158 -2.97833 -26.833 8.04502 +6074 4 42.4661 20.0651 5.41852 11.3272 16.2867 -2.99003 +6075 6 21.5372 23.2991 30.4448 -14.935 11.2275 -26.3705 +6076 4 20.9947 23.0537 31.1809 -7.12546 -6.28648 20.8256 +6077 4 20.8648 23.582 29.7655 22.6032 -4.28693 10.3415 +6078 6 0.251317 28.0486 36.1651 -22.0243 21.0356 -19.5016 +6079 4 1.02049 27.7114 36.6113 18.9729 -1.47718 6.47801 +6080 4 0.506474 28.8456 35.6445 2.58205 -12.8812 9.00708 +6081 6 3.04678 17.0589 11.5707 1.23946 -7.00965 -18.5436 +6082 4 3.14519 17.2619 12.4977 -1.89892 8.1653 13.6088 +6083 4 2.54959 17.7766 11.1613 1.73961 1.36316 5.23635 +6084 6 24.1645 37.0333 23.9496 -13.0802 10.7124 17.6799 +6085 4 23.6099 37.8384 23.8849 6.1763 -9.33563 -1.28122 +6086 4 24.4663 37.0147 24.8893 -3.58635 -1.49958 -18.3056 +6087 6 3.94341 20.5209 27.4789 6.12038 36.4957 26.1587 +6088 4 3.64002 20.0757 26.7101 -13.0247 -10.3927 -30.3524 +6089 4 3.8213 21.4921 27.3096 0.6263 -21.942 -1.90407 +6090 6 54.8381 2.78983 29.6272 25.3782 12.002 29.7256 +6091 4 54.8259 2.49183 30.5832 -3.08894 8.50949 -25.0172 +6092 4 0.681738 3.33643 29.5869 -23.0163 -14.7319 0.890579 +6093 6 27.1738 8.43221 31.7209 4.37325 44.8318 10.1666 +6094 4 26.7765 8.21235 30.8513 3.34031 12.9925 0.247925 +6095 4 27.4394 9.43578 31.8184 -18.7706 -51.1708 -12.8964 +6096 6 30.9422 1.62815 30.3909 7.68258 9.19266 14.5116 +6097 4 30.6848 0.902997 29.8247 -17.6873 -14.6962 -9.63211 +6098 4 30.1385 1.96768 30.8202 -2.70664 -9.08975 -4.26502 +6099 6 26.4126 36.4396 36.8407 14.7094 2.78685 2.16538 +6100 4 26.1754 35.936 36.0621 -1.37556 -1.6634 -9.1832 +6101 4 27.3614 36.6667 36.7609 -11.9856 -2.56278 0.470716 +6102 6 51.3051 10.055 21.7064 16.9271 -12.7171 -0.47742 +6103 4 50.71 9.38094 22.0984 13.3581 11.7028 -6.50503 +6104 4 52.1297 9.58932 21.3894 -28.6693 12.5934 9.83408 +6105 6 52.4269 12.3712 23.2743 -6.4707 23.0639 13.1163 +6106 4 51.7645 13.1043 23.2119 13.6159 -11.3613 1.42096 +6107 4 52.024 11.6223 22.842 -6.69009 -13.0182 -9.76131 +6108 6 10.0084 38.37 20.6075 21.9453 -2.41338 -4.30271 +6109 4 9.45069 38.2813 21.3825 -6.19229 -0.201962 6.85596 +6110 4 10.9137 38.1225 20.8794 -8.5598 0.614521 -3.9406 +6111 6 22.7031 33.2664 0.640708 10.9794 6.62646 4.85135 +6112 4 23.6679 33.2996 0.582378 1.56947 7.5672 2.73741 +6113 4 22.5144 32.4288 0.230474 -14.5468 -15.5809 -6.04383 +6114 6 14.0917 40.8812 25.4864 9.18744 8.89463 -14.7226 +6115 4 14.196 40.6884 26.4283 -5.63746 -5.20078 0.271339 +6116 4 13.2439 40.5125 25.1796 5.27736 1.6069 9.18822 +6117 6 42.7681 15.0783 14.9763 7.15748 5.71054 -2.59845 +6118 4 43.0785 15.7158 14.2901 -5.10451 -16.9901 16.8665 +6119 4 41.8327 15.2592 15.1092 -5.54173 -0.124331 1.80857 +6120 6 30.2406 7.22111 8.53832 -0.545825 26.9265 -4.64375 +6121 4 30.1758 8.19473 8.52708 -1.1145 -9.52086 -16.9196 +6122 4 30.4024 7.07989 9.45321 5.06633 -17.0605 24.2519 +6123 6 3.37759 19.8423 41.3077 23.4194 0.89426 -0.123069 +6124 4 3.19865 19.3681 40.4829 0.842743 3.23829 1.04749 +6125 4 4.34953 20.0012 41.2688 -20.407 -4.57585 2.1738 +6126 6 8.87423 25.1354 17.2017 -10.0567 -4.23249 -18.7298 +6127 4 8.96932 24.947 16.2256 5.94886 2.92938 28.6011 +6128 4 9.65182 24.8278 17.6915 0.0257745 -5.63434 -9.64419 +6129 6 9.32494 14.9555 22.0283 -12.5325 4.5599 7.62514 +6130 4 9.01993 14.8718 22.9489 -0.27625 1.365 -7.1979 +6131 4 10.1958 14.5523 22.0148 2.38734 -2.44115 -2.54227 +6132 6 2.03086 4.7751 20.8592 -0.302533 -25.5342 -8.8148 +6133 4 2.76807 5.37577 20.9697 7.90436 11.3601 5.00545 +6134 4 1.2576 5.15949 21.2703 -7.54078 11.376 6.7073 +6135 6 18.2964 7.06718 3.86051 -0.633466 1.54328 39.8902 +6136 4 18.916 7.22135 3.16498 20.2468 5.35447 -22.1173 +6137 4 18.8081 6.54637 4.52758 -12.8964 10.087 -8.61721 +6138 6 17.0178 19.1734 19.8425 8.05121 8.342 4.19715 +6139 4 17.786 18.9037 19.3194 -9.06534 -4.96345 -2.22737 +6140 4 16.269 18.585 19.6427 11.1227 0.819232 -3.01639 +6141 6 4.30363 6.55267 21.3463 7.67654 -0.43578 -3.38259 +6142 4 4.33009 7.06923 20.5107 4.36212 -5.74714 10.2686 +6143 4 5.22777 6.26626 21.5669 -20.6993 9.2157 -12.5452 +6144 6 20.7848 36.9284 35.662 4.03453 1.95325 3.7669 +6145 4 20.2254 37.0836 34.8976 -2.25577 1.87165 -3.27163 +6146 4 20.2383 36.4327 36.2875 0.848364 -0.11832 4.44878 +6147 6 4.7306 15.0205 31.2333 -1.91968 -20.8619 8.65585 +6148 4 4.4229 14.7734 32.1398 6.18773 10.2906 -17.1472 +6149 4 4.73385 15.973 31.1263 -2.35963 8.87481 4.31723 +6150 6 2.35358 1.22877 17.5767 10.9459 -8.92502 -6.22121 +6151 4 3.05741 1.28614 16.8672 -19.772 5.07478 19.7417 +6152 4 1.94409 2.09607 17.7592 7.86728 -5.07336 -5.26938 +6153 6 34.6221 31.5613 19.8029 0.0167231 -1.91103 -0.857839 +6154 4 35.0026 31.8698 18.9629 1.12657 -3.13716 4.28436 +6155 4 34.4223 32.3623 20.3103 -0.485441 0.265221 -3.01806 +6156 6 24.1912 21.6103 13.5173 31.6251 8.72647 13.7111 +6157 4 25.0921 21.8731 13.8418 -25.6554 -7.43575 -12.369 +6158 4 23.5893 22.1875 13.984 -2.65104 7.77201 2.87587 +6159 6 37.2187 41.0834 5.69361 1.76676 -13.0415 -0.936073 +6160 4 37.8761 41.7354 5.91144 16.7665 3.57334 0.125879 +6161 4 36.4089 41.5349 5.88363 -19.4064 5.82624 -1.33385 +6162 6 8.4323 8.00063 20.2395 28.2224 -17.334 -6.20124 +6163 4 9.29892 8.115 20.6547 2.73811 -3.60152 -0.447724 +6164 4 7.94828 8.69862 20.6224 -29.3938 29.4062 12.6481 +6165 6 14.9357 18.8843 36.7618 11.8158 33.7978 0.271425 +6166 4 14.1259 19.2123 36.362 -3.40669 -6.42507 -0.135577 +6167 4 15.5651 19.6361 36.6422 -7.52364 -17.7077 5.06346 +6168 6 43.9725 40.6444 18.6569 4.16672 -2.33153 16.0012 +6169 4 43.9166 40.834 17.7203 0.682613 4.51617 -13.4207 +6170 4 44.9212 40.6761 18.9032 -12.0211 -3.47257 -3.21486 +6171 6 33.7852 32.2494 37.3449 -11.8504 2.76306 -14.1758 +6172 4 34.0177 32.2775 36.4055 -1.41242 -0.232407 11.1732 +6173 4 34.3686 31.6236 37.7745 10.7747 -2.06792 3.13276 +6174 6 5.09749 29.2901 24.0356 16.7213 -6.5526 19.7529 +6175 4 5.77222 29.487 24.7328 -11.5239 -2.29901 -14.2657 +6176 4 4.7684 30.1321 23.7215 -1.73734 11.0072 -2.10513 +6177 6 33.6153 36.4198 10.9805 1.47517 3.52666 5.33615 +6178 4 32.7579 36.4403 10.5596 -3.06779 3.10292 -7.60642 +6179 4 33.384 36.4828 11.91 5.71512 -0.747971 7.16991 +6180 6 28.3006 33.5952 13.1115 6.62888 -15.4249 13.7129 +6181 4 27.948 33.7778 12.2398 -4.56551 -8.24283 -4.77521 +6182 4 28.1705 32.6462 13.2914 -0.364449 12.3294 -7.26248 +6183 6 6.16378 19.058 24.2919 3.99573 -9.29146 -27.7059 +6184 4 6.01812 19.825 24.8144 -3.49512 27.1397 16.8881 +6185 4 6.29927 18.3335 24.8859 3.7649 -20.2974 16.0908 +6186 6 28.4267 19.9356 1.8581 6.30761 1.98196 1.30153 +6187 4 28.5945 19.3745 1.10227 -2.74725 -9.675 -9.29711 +6188 4 29.2893 20.1184 2.23075 1.76934 5.71608 2.57016 +6189 6 42.0557 23.969 9.55925 -0.174378 -1.97525 4.49576 +6190 4 42.3037 23.8044 10.4694 5.92504 9.79373 11.5418 +6191 4 41.7282 23.1152 9.29053 -8.19873 -12.6145 -11.7634 +6192 6 43.5187 7.30226 27.4319 7.08124 -12.3985 0.368771 +6193 4 42.7424 7.14751 27.9838 -5.23639 1.01312 3.8871 +6194 4 43.2552 7.97753 26.8025 -4.71413 8.37143 -8.21745 +6195 6 20.4824 33.0041 9.27291 -32.573 -27.3267 34.6611 +6196 4 19.7824 32.5876 9.93875 35.2414 32.5831 -36.6535 +6197 4 20.3431 33.9616 9.1663 -10.2228 -2.75758 9.24016 +6198 6 38.0326 35.2526 15.9362 -7.94884 -19.6622 -5.99631 +6199 4 37.3459 34.9971 15.2894 4.63074 2.95951 5.93375 +6200 4 37.9463 34.6017 16.6504 2.45283 5.99568 -2.76115 +6201 6 47.5301 20.8853 3.96175 -5.34824 -5.66637 20.3565 +6202 4 47.9759 21.3648 3.2498 -4.9297 7.97101 8.48596 +6203 4 47.5029 21.3928 4.81786 6.75175 -1.3172 -26.6206 +6204 6 10.9933 31.6966 41.4271 11.47 5.02521 -0.853614 +6205 4 11.6392 31.7665 40.7132 0.112137 -5.28149 3.10577 +6206 4 10.1353 31.6993 40.998 -8.62143 -0.203152 -1.66696 +6207 6 43.2403 12.6562 2.57215 9.62694 -8.68348 -18.5989 +6208 4 42.9077 12.993 3.39384 -2.38679 2.43178 19.528 +6209 4 44.033 12.1261 2.78242 -8.9232 8.2725 3.71991 +6210 6 49.4204 25.4105 21.1683 5.59269 -12.2048 -2.72561 +6211 4 50.0196 25.2987 20.4097 -7.64964 4.29225 2.01473 +6212 4 48.8877 24.5919 21.195 1.69169 7.44836 1.02425 +6213 6 1.95674 34.1403 26.4747 8.8762 -24.2704 6.47661 +6214 4 2.77674 33.6103 26.5537 -12.4269 14.6955 -4.62849 +6215 4 1.26657 33.4613 26.3994 -1.21739 9.31774 -1.03397 +6216 6 17.1306 20.8229 36.6851 -31.9931 14.1441 13.8122 +6217 4 16.9533 21.7471 36.9985 5.62896 -19.6931 -5.93312 +6218 4 18.0634 20.696 36.5868 23.783 -2.64609 -3.70934 +6219 6 36.6048 10.9866 3.71548 -5.44552 8.31799 24.2539 +6220 4 35.7423 11.3886 3.87785 -5.6936 5.55042 -13.8219 +6221 4 36.8135 10.7077 4.61447 10.9535 -7.59336 -0.361553 +6222 6 14.2169 20.6838 21.9439 11.6961 23.12 -6.3106 +6223 4 13.8085 20.2376 21.1912 1.98746 8.13024 -7.83415 +6224 4 14.8103 21.4259 21.6461 -14.674 -27.097 -1.82439 +6225 6 33.9151 12.2544 9.54899 39.8857 -26.0408 -21.0892 +6226 4 34.3088 11.5163 10.0208 11.0461 -3.70138 -11.6499 +6227 4 33.2997 12.4814 10.1903 -47.9458 31.9244 32.2008 +6228 6 21.8056 41.4836 2.15686 0.64336 -1.87746 -8.80618 +6229 4 22.0354 41.6672 1.22189 -5.57638 1.91412 12.8342 +6230 4 22.5122 40.9391 2.50884 5.16687 -0.375256 0.644554 +6231 6 20.9282 10.4547 14.1996 25.019 -0.0729632 25.5582 +6232 4 21.5922 10.842 14.8375 -21.0894 -6.80718 -21.5316 +6233 4 20.826 9.54084 14.5456 -0.887825 12.9084 -9.51249 +6234 6 6.24616 4.45231 24.6293 -10.9468 0.993291 2.39826 +6235 4 6.83688 4.17894 23.9311 12.242 -0.137787 -14.9911 +6236 4 5.68087 3.68408 24.7586 -3.59028 -1.51582 -1.5433 +6237 6 50.784 14.5954 23.4824 21.8736 9.84292 5.60122 +6238 4 51.2681 15.1205 24.1582 -9.03857 -7.6656 -10.4761 +6239 4 49.9341 14.3608 23.8519 -7.60536 -4.54693 6.65168 +6240 6 52.7678 13.9144 9.68214 -3.90955 36.1598 -0.40974 +6241 4 52.8738 13.0144 9.92216 4.47335 -34.5538 7.53363 +6242 4 51.8729 14.0092 9.35938 -14.036 0.105332 -6.17221 +6243 6 9.05048 2.05234 29.9152 -29.3842 -12.1538 -14.6176 +6244 4 9.42756 2.83336 30.2687 13.3628 24.1087 13.7335 +6245 4 8.09173 2.26823 29.8032 18.9866 -6.39081 0.174186 +6246 6 7.13499 29.9757 26.2377 7.52656 -33.046 2.78556 +6247 4 6.52748 30.39 26.8607 -0.20976 -1.88395 4.87081 +6248 4 7.49713 29.1538 26.6869 -11.4544 24.9502 -11.4644 +6249 6 49.1541 41.742 14.3355 11.4439 21.5488 -10.6063 +6250 4 49.5333 41.2573 13.5835 -2.72613 -5.13007 3.47372 +6251 4 49.526 0.750494 14.2401 -8.50163 -23.9907 2.80869 +6252 6 5.64545 3.82333 19.1929 -5.43924 -10.1162 19.2647 +6253 4 5.12472 3.39384 19.906 6.51959 7.46947 -11.8792 +6254 4 5.07872 3.8651 18.4273 -3.31865 2.78603 -7.74707 +6255 6 9.32747 35.8381 24.9081 -3.67476 7.0144 6.61099 +6256 4 10.2167 35.7622 24.5243 -1.5306 1.39279 3.84516 +6257 4 9.42305 36.4736 25.6393 1.10498 -0.920313 -3.33942 +6258 6 53.0258 29.7567 11.5493 -1.29773 -2.97991 8.71205 +6259 4 53.4398 30.4104 10.9769 2.6525 4.63524 -3.89524 +6260 4 52.8324 30.2122 12.386 1.27544 -1.91261 -4.55584 +6261 6 22.6082 9.97702 5.69106 1.45951 -2.04334 43.7981 +6262 4 23.4598 10.2484 6.09617 -7.85329 -3.83944 -13.5574 +6263 4 22.5497 10.2693 4.79236 2.60512 5.60546 -21.7219 +6264 6 39.5532 19.6216 2.68726 -3.50035 -14.5445 -22.3968 +6265 4 38.6563 19.3067 2.54039 -1.65167 0.121811 17.9309 +6266 4 39.9003 19.405 1.80953 18.3116 7.78412 6.67062 +6267 6 45.082 35.5833 7.81025 20.3465 -2.3491 -25.2688 +6268 4 45.1219 36.3229 8.40611 -5.73741 11.9797 15.8104 +6269 4 44.452 34.9332 8.12016 -12.4923 -3.86067 9.83054 +6270 6 29.7976 14.244 9.96067 -5.32248 -4.64296 1.12628 +6271 4 30.0443 14.0971 9.02808 -4.18819 -1.64606 2.67632 +6272 4 28.8444 14.0269 10.0606 18.5465 4.64021 -4.02524 +6273 6 29.2523 30.155 21.8932 -5.77992 6.30922 3.94049 +6274 4 29.1431 30.8143 21.21 -7.42967 10.4849 -3.0507 +6275 4 30.0153 29.6632 21.6201 11.6336 -14.2167 -2.13367 +6276 6 11.1107 18.8213 6.56056 -14.6836 -1.88929 0.635516 +6277 4 11.166 19.7501 6.27543 7.98891 -2.6539 -0.194038 +6278 4 11.9915 18.4225 6.59495 6.41359 9.14832 -2.51569 +6279 6 13.4142 39.1371 13.4638 17.7807 -10.3765 -23.6259 +6280 4 13.7831 39.7975 14.0449 5.16656 9.87024 9.85065 +6281 4 12.6066 38.8468 13.8734 -16.0883 -5.26763 6.93978 +6282 6 50.1521 12.9948 0.13749 23.7903 11.3983 42.7862 +6283 4 49.8531 12.6437 41.2486 -17.3674 -16.2897 -43.7514 +6284 4 50.6811 12.2823 0.528204 -2.61001 5.26075 1.59628 +6285 6 47.8279 31.3538 27.7873 0.535952 -14.579 -21.2406 +6286 4 47.8981 31.8966 28.5732 -11.876 9.28639 5.42067 +6287 4 46.9879 31.5201 27.3031 12.1261 3.81279 14.9113 +6288 6 27.708 1.63283 7.49454 14.1634 -3.44528 -21.3886 +6289 4 26.9442 1.71926 8.04828 -16.4795 3.87106 10.0363 +6290 4 27.4331 1.03137 6.77318 -2.44435 3.14912 6.58235 +6291 6 54.8843 20.7912 16.041 -0.591057 -23.5277 -19.4313 +6292 4 54.9506 20.9946 16.9763 2.49267 -3.51754 11.2958 +6293 4 0.215527 19.8591 15.8725 -6.64294 24.8159 10.1677 +6294 6 37.4309 32.9919 34.4461 -3.01999 17.5498 0.613574 +6295 4 37.2599 32.074 34.6492 -8.98721 -14.1314 1.69718 +6296 4 36.602 33.3843 34.0789 10.8556 -9.90957 7.57788 +6297 6 19.516 39.775 6.74949 1.2991 -23.719 -0.568837 +6298 4 19.1628 39.2461 5.9771 11.6696 10.1577 21.4746 +6299 4 19.8715 39.1258 7.41882 -10.6166 14.587 -19.1486 +6300 6 32.439 2.74298 8.0597 2.15016 14.1028 28.0311 +6301 4 32.8474 3.04427 8.91221 -2.20578 -4.83758 -21.9226 +6302 4 31.6043 2.37221 8.38063 -2.27075 -4.50389 -9.9889 +6303 6 12.9757 16.0783 4.05517 0.782156 -17.4841 -11.0101 +6304 4 12.5393 15.6612 4.81952 2.97976 0.136191 -5.67644 +6305 4 13.3707 15.3387 3.55371 -3.64889 7.0956 8.52646 +6306 6 4.65115 29.9533 5.41887 4.80886 14.2508 -32.4371 +6307 4 5.0407 30.2031 4.52094 -17.5959 -12.1853 28.663 +6308 4 3.95879 29.263 5.26663 23.43 17.9812 0.878069 +6309 6 29.754 32.1152 24.0535 7.2798 7.01713 3.37681 +6310 4 30.6602 32.1649 24.4187 -11.1956 -0.828668 -6.39664 +6311 4 29.7572 31.4388 23.3746 -2.03067 -7.97912 -3.55015 +6312 6 11.8649 30.6972 33.4692 4.66278 -43.8766 26.3819 +6313 4 11.8723 29.8544 34.0435 -6.78391 38.5593 -23.2698 +6314 4 12.7601 30.7129 33.1118 -0.162199 2.5806 0.32685 +6315 6 17.3589 40.4121 27.3072 22.6925 26.1242 -9.80885 +6316 4 17.3318 41.3765 27.4299 10.8839 -2.3351 -5.50809 +6317 4 16.5554 40.1462 27.6883 -41.5002 -17.3681 16.6281 +6318 6 8.67113 4.89706 8.92484 12.0335 -9.87957 -4.1983 +6319 4 8.33733 5.39218 8.1724 -5.0195 2.6367 -1.72337 +6320 4 8.22391 5.22927 9.70847 -2.49168 4.71619 2.25155 +6321 6 39.5722 17.6819 9.57834 18.7012 -23.4437 -36.958 +6322 4 39.2207 17.6668 10.4653 -7.32211 -9.11094 11.7967 +6323 4 39.6226 16.7555 9.16114 -8.90732 35.1542 21.3272 +6324 6 31.4906 30.1663 28.5669 -18.2413 -3.40307 10.1233 +6325 4 32.2933 30.4252 28.099 2.93126 -8.695 5.25695 +6326 4 31.6493 29.3506 29.0723 8.50077 6.58979 -7.17605 +6327 6 52.667 19.2904 40.0609 -3.10376 4.72625 -3.48654 +6328 4 52.9542 18.5867 39.4362 -2.88314 13.2503 8.01058 +6329 4 53.0181 20.1618 39.7754 -0.243354 -8.89628 -7.05583 +6330 6 3.24103 7.80987 9.85575 15.4795 13.9798 -0.387217 +6331 4 3.75934 8.59525 10.1836 -13.0283 -21.6848 -11.3123 +6332 4 3.84189 7.30622 9.27659 -5.58147 6.91981 6.81825 +6333 6 23.1336 35.2172 35.587 -21.8844 -14.3383 30.559 +6334 4 23.8289 35.3646 34.9695 18.2116 12.6911 -23.5817 +6335 4 22.438 35.8962 35.5045 5.76256 0.966742 -5.52301 +6336 6 19.4997 14.0668 20.8253 -20.4482 -5.33672 -12.8711 +6337 4 19.9465 14.5101 21.5526 -0.10572 6.16799 9.82761 +6338 4 18.517 14.0876 20.9737 19.1914 1.01522 3.6393 +6339 6 23.6166 15.8675 24.0247 18.6101 -11.8924 -11.0295 +6340 4 23.7056 16.8159 24.0204 -5.88143 19.7526 4.0278 +6341 4 24.4592 15.5679 23.6279 -14.5441 0.474754 5.50536 +6342 6 0.271665 30.4941 6.10208 19.3679 10.4089 38.3983 +6343 4 55.0639 30.1609 5.24948 -13.9023 -9.5098 -30.2095 +6344 4 54.47 30.83 6.54681 -8.02886 -2.57547 -7.81581 +6345 6 4.88814 13.205 29.1223 -11.8587 -43.2127 -22.2411 +6346 4 4.78002 13.8458 29.7909 -3.08187 32.2273 31.1649 +6347 4 5.63816 13.4614 28.593 12.4558 6.3486 -8.85318 +6348 6 54.2078 27.2696 19.1963 -15.9712 -23.151 25.2067 +6349 4 0.0774591 27.3551 19.591 11.6552 0.895327 2.86932 +6350 4 54.2345 27.7605 18.3958 2.66703 17.7524 -27.3595 +6351 6 13.918 35.7451 9.18145 -1.78919 -38.7722 -17.1362 +6352 4 13.6805 34.9997 8.54227 8.11159 28.2534 18.027 +6353 4 13.9675 36.5302 8.63631 -0.993585 8.08981 -9.4946 +6354 6 5.91273 31.9181 18.8024 -12.4461 1.37758 17.74 +6355 4 5.51416 32.8097 18.9023 4.86685 -6.68339 -12.1033 +6356 4 6.30341 31.7597 17.9414 -1.0189 10.0948 -10.5031 +6357 6 5.79665 28.8753 9.48388 1.22923 1.68801 -9.18455 +6358 4 5.13151 29.3325 10.0083 -4.81051 1.68465 1.48607 +6359 4 5.29369 28.2634 8.9143 2.26517 5.17431 2.85494 +6360 6 40.1173 6.05944 9.72118 13.8961 -11.6659 -14.1698 +6361 4 40.0092 6.65032 8.94634 5.33155 -13.6 11.5113 +6362 4 40.8322 5.39707 9.49335 -23.1878 23.6737 0.508505 +6363 6 20.33 13.449 41.3936 11.1096 -0.534149 -19.18 +6364 4 21.2311 13.7006 41.7531 -26.0398 -5.61362 -19.048 +6365 4 20.2547 13.6822 40.4168 8.50391 -3.95591 26.8537 +6366 6 14.4455 21.736 27.3642 10.1345 -2.11962 18.0607 +6367 4 15.3888 21.7922 27.5976 -10.3958 0.0660495 -7.924 +6368 4 14.3649 21.6255 26.4124 4.42937 0.724974 -0.20238 +6369 6 38.7561 1.79551 30.0553 7.9914 -17.3849 -15.575 +6370 4 38.4573 2.01955 30.9195 -8.42419 6.13431 27.6354 +6371 4 38.9299 2.64677 29.6557 3.10695 8.29419 -8.65227 +6372 6 5.60526 10.8558 14.1801 -12.7318 -17.5226 5.68918 +6373 4 4.9397 11.5438 14.0518 -0.153792 0.369728 -2.18729 +6374 4 5.10481 10.0791 14.5379 11.5553 16.0131 -9.09073 +6375 6 45.3957 36.7129 27.9145 12.4213 23.5208 -28.0365 +6376 4 46.0624 36.7782 28.6036 -4.12954 -6.22049 8.27184 +6377 4 45.8092 37.2197 27.1638 -19.7894 -19.9635 17.4029 +6378 6 54.0798 35.0308 20.3994 -2.843 -1.86615 -11.5734 +6379 4 53.8804 34.0877 20.4832 1.52986 -2.36109 -0.337181 +6380 4 53.937 35.2424 19.4598 0.882668 -0.831705 10.9264 +6381 6 42.0694 14.2202 28.4717 21.1483 -3.98018 21.7174 +6382 4 41.9885 13.9669 29.4143 -10.3093 2.59547 -11.4583 +6383 4 43.02 14.3987 28.405 -3.82604 1.35242 -7.96462 +6384 6 34.8498 7.69636 26.7062 10.2576 -3.81921 3.94078 +6385 4 35.6291 7.30563 27.124 0.895866 5.46509 7.50645 +6386 4 34.5698 7.0105 26.0965 -7.64543 -1.95318 -6.87837 +6387 6 49.6738 30.7035 23.8555 -19.3272 -4.41511 -13.3992 +6388 4 50.4901 31.166 23.8286 28.3544 13.2291 -0.764283 +6389 4 49.8241 29.9642 24.4268 4.30872 -17.0733 16.2757 +6390 6 50.9008 7.796 14.1645 9.55664 -5.64416 8.78132 +6391 4 50.8079 7.01141 13.6383 2.57079 -23.1487 -4.84087 +6392 4 50.5017 8.45024 13.6177 -13.1237 27.0593 -11.2067 +6393 6 4.26801 39.4668 27.8349 5.05862 -9.29033 0.915363 +6394 4 3.69733 40.2352 27.9464 -2.13812 3.43039 0.251988 +6395 4 3.85787 38.9439 27.1453 -8.48589 -4.99062 -8.23097 +6396 6 8.74801 32.8245 8.20645 -16.3778 -23.5545 -4.64115 +6397 4 8.1587 32.1369 7.77132 15.1044 25.0089 5.08958 +6398 4 8.83862 33.6223 7.65804 -4.44885 -3.27239 -3.39484 +6399 6 52.9644 25.4956 9.38778 -23.0628 41.5097 8.07386 +6400 4 51.9653 25.4466 9.50894 36.2156 4.27363 -7.84863 +6401 4 53.1697 26.4737 9.50477 -8.20239 -39.1491 -3.41364 +6402 6 29.5595 36.7246 19.4744 18.9803 -2.04176 16.4704 +6403 4 29.6949 37.303 18.726 -4.20274 3.37351 -9.90607 +6404 4 30.4598 36.6303 19.854 -15.3589 -5.02994 0.251134 +6405 6 52.32 36.0811 25.1124 8.57954 -21.5781 -32.5589 +6406 4 53.081 35.9362 25.6725 3.50304 3.9365 6.54391 +6407 4 51.6308 36.4579 25.6293 -16.5409 10.2166 18.3955 +6408 6 21.1806 15.7021 31.1799 -1.73968 4.64344 -14.8668 +6409 4 20.7524 16.2958 30.5301 6.89899 -9.15256 14.6363 +6410 4 20.4997 15.2544 31.7027 -1.32541 3.0922 -5.22806 +6411 6 10.6615 22.4234 39.4446 2.77058 -10.3375 -21.7461 +6412 4 10.8237 22.5242 38.4595 -6.54577 -4.89624 27.0726 +6413 4 10.2823 21.5329 39.6036 8.10661 10.4602 -7.72978 +6414 6 25.1119 11.6683 22.7275 17.9584 10.1803 -43.002 +6415 4 25.2932 11.5881 23.6503 -10.3644 -4.73542 30.1579 +6416 4 24.2275 11.4525 22.4127 -3.04384 -6.16919 15.0614 +6417 6 31.7847 10.4664 2.90738 14.6232 4.92747 -25.5509 +6418 4 32.6367 10.8084 3.16838 3.35352 3.27745 17.8769 +6419 4 31.9203 10.4929 1.94425 -15.217 -5.45404 8.94289 +6420 6 52.4827 36.4345 22.1596 -7.80713 -36.8893 3.58418 +6421 4 53.0619 36.0081 21.4904 -7.85296 7.00584 7.09748 +6422 4 52.1113 35.6558 22.6625 11.8438 27.843 -13.8236 +6423 6 46.2218 40.0356 27.0002 3.00948 19.3103 18.0239 +6424 4 46.4695 39.2891 26.4839 7.60887 -23.2108 -12.3358 +6425 4 45.8298 40.6551 26.3816 -4.98516 2.75312 2.41297 +6426 6 24.0859 36.731 39.1057 28.0861 3.14637 -13.7231 +6427 4 23.7868 35.8298 38.9338 -5.18553 -0.74556 5.28182 +6428 4 23.4629 37.185 39.6652 -17.6872 -1.49015 10.8999 +6429 6 22.3474 7.42423 31.8108 -22.1464 -34.764 6.81692 +6430 4 22.3426 8.34479 32.0749 -0.491553 12.3501 5.32307 +6431 4 21.6443 6.94951 32.3421 24.5486 22.6275 -17.4273 +6432 6 14.3601 18.3609 4.10227 -5.91068 -17.6869 34.0105 +6433 4 14.0198 17.4467 4.00899 4.58845 16.3972 -3.13031 +6434 4 14.1964 18.4938 5.07185 10.0688 2.42213 -23.7444 +6435 6 27.3176 38.4584 0.118061 26.6324 1.72941 22.4386 +6436 4 26.8721 39.2229 0.514978 -6.24738 0.955789 -1.68833 +6437 4 28.1825 38.4197 0.615747 -27.5588 -2.17115 -12.0629 +6438 6 18.6641 0.153005 12.2455 -30.1585 11.9093 7.70812 +6439 4 17.6838 0.288413 12.4195 29.795 -10.6896 -3.23208 +6440 4 18.9224 41.3021 12.7767 -6.14336 -8.14908 8.56265 +6441 6 49.4289 24.9791 25.34 -2.93287 6.40986 -7.21031 +6442 4 48.5336 24.6845 25.5066 -4.79022 -10.2209 3.00881 +6443 4 49.2657 25.7332 24.7569 10.0796 0.538989 -0.302405 +6444 6 52.0657 20.2866 15.752 -30.988 -5.77477 12.2451 +6445 4 52.9883 20.4648 15.7877 30.7647 6.19501 2.10932 +6446 4 51.7487 20.318 16.6754 2.59628 0.707672 -8.61894 +6447 6 49.6694 15.6466 38.5033 -2.36871 5.8496 0.21755 +6448 4 49.1634 15.9354 37.7317 2.81773 -6.75889 -8.88584 +6449 4 49.3364 16.2327 39.1899 -1.1635 1.82265 11.9188 +6450 6 15.9209 23.7098 13.4125 14.0576 3.0382 28.6395 +6451 4 16.4576 23.7581 14.2247 -6.14337 -14.5589 -15.9509 +6452 4 15.4928 24.5639 13.4473 -12.8057 7.70559 -12.0572 +6453 6 14.3535 29.1644 14.3158 -5.44214 8.41065 -10.6214 +6454 4 14.1107 29.5404 13.4323 4.3831 -8.60004 22.5031 +6455 4 14.1668 29.874 14.9595 1.02369 -3.68708 -8.8215 +6456 6 30.4209 19.8501 16.8941 13.513 -29.8099 -4.40702 +6457 4 30.8419 19.6061 17.7309 -1.16118 4.00396 0.0836579 +6458 4 29.8867 20.6126 17.0073 -13.0379 22.0094 6.56408 +6459 6 21.3171 21.0315 23.1347 13.77 4.04154 19.3244 +6460 4 22.2214 21.2364 23.4619 -15.8088 -1.32345 -6.31481 +6461 4 20.7299 21.1568 23.8987 5.07857 1.54253 -3.54042 +6462 6 32.3393 0.431439 25.2563 20.1104 -9.0179 2.05206 +6463 4 32.3376 0.357033 24.2893 -5.83171 4.85221 4.50445 +6464 4 31.4939 0.740536 25.5658 -20.5297 5.12544 -3.04931 +6465 6 26.1412 32.4208 27.5133 11.9844 8.82666 12.5058 +6466 4 25.6297 33.2181 27.3271 -3.7928 0.326337 -6.17907 +6467 4 25.9506 31.7475 26.8638 -6.12498 -3.36782 -14.5181 +6468 6 31.6886 23.0183 41.4596 0.904697 7.64904 11.3452 +6469 4 32.5758 22.6752 41.6838 -11.075 0.532718 -2.08438 +6470 4 31.0649 22.7115 0.227606 5.71652 1.16966 -4.3825 +6471 6 54.3662 17.838 10.7289 1.16641 13.6113 28.4031 +6472 4 53.5784 18.2682 10.4091 -15.835 11.3767 1.3744 +6473 4 54.5574 17.2244 10.05 12.0924 -25.2322 -22.7117 +6474 6 15.4007 28.5656 8.62044 -26.1749 5.76845 -41.3303 +6475 4 14.7273 28.9702 8.01425 13.7656 -2.21873 23.1298 +6476 4 15.8479 27.9621 8.001 5.22436 1.48231 12.0756 +6477 6 21.9302 22.318 27.6758 1.68517 -22.7815 -10.3197 +6478 4 22.2029 23.2377 27.6948 5.32233 7.77922 8.4028 +6479 4 21.9507 21.9579 28.5708 1.77406 4.33165 6.10734 +6480 6 2.9439 17.0434 8.14058 1.94164 -24.3442 -12.3304 +6481 4 3.71771 17.0381 7.53295 -10.9103 8.58946 10.7103 +6482 4 2.9095 17.8301 8.67828 12.1388 15.179 1.9509 +6483 6 27.5776 18.2769 3.9771 26.0492 -34.2565 5.18616 +6484 4 26.8914 18.9079 3.85686 -19.1066 25.6869 -8.0303 +6485 4 28.3968 18.6065 3.57961 -12.2542 3.89161 2.52414 +6486 6 24.7648 24.5394 8.45172 0.675902 5.99664 -6.73781 +6487 4 25.0691 23.6382 8.29185 0.995795 -2.08458 0.0885467 +6488 4 24.6379 24.6158 9.40394 1.7631 1.80546 -0.516948 +6489 6 41.9985 30.4652 13.7873 -12.418 22.2399 8.0521 +6490 4 42.948 30.5766 13.6065 -4.54142 -18.1038 -0.632901 +6491 4 41.6543 29.5567 13.7855 17.2179 -0.450275 -1.52495 +6492 6 15.7003 34.688 41.5836 22.5583 -4.71252 2.77114 +6493 4 16.4414 35.3131 41.7067 -7.89455 1.74939 1.29748 +6494 4 14.9091 35.1782 41.7999 -10.5684 8.94915 5.66738 +6495 6 11.14 19.7709 40.5827 8.16812 -24.8495 -13.7269 +6496 4 12.099 19.6958 40.4335 -6.97557 5.6239 6.72769 +6497 4 10.8269 18.8658 40.3418 -4.09458 16.1616 8.77151 +6498 6 47.4994 34.5266 14.3059 -7.29954 -13.2064 -47.3862 +6499 4 46.9486 35.2618 14.0194 -1.26876 14.2822 14.9014 +6500 4 47.5134 34.0178 13.447 14.161 -1.19014 30.6955 +6501 6 12.4113 26.9599 28.4986 7.53387 -39.615 -11.3807 +6502 4 13.2389 26.8759 29.0383 -9.69033 -7.26437 -10.917 +6503 4 12.3547 26.143 27.8911 8.77392 33.3418 27.7102 +6504 6 27.6324 16.2078 39.8226 -15.7166 38.3334 10.2244 +6505 4 27.1738 15.4871 40.2515 -0.529449 -16.0233 0.418904 +6506 4 28.2783 15.8881 39.2072 13.4358 -18.0852 -11.4488 +6507 6 33.41 31.2223 27.2648 1.06056 32.1352 -34.8736 +6508 4 34.1408 31.8147 27.4795 4.37007 -7.45055 8.12396 +6509 4 32.9956 31.7298 26.5244 2.74339 -19.701 12.9858 +6510 6 39.1079 39.5697 31.9277 -2.55925 2.09297 0.92959 +6511 4 38.7672 39.6549 31.0188 2.43701 -1.71218 7.87361 +6512 4 38.6143 40.212 32.4659 5.60044 -5.69156 -1.85126 +6513 6 22.8777 16.5449 19.9566 -5.65986 -8.80894 -1.36967 +6514 4 23.3352 15.8067 20.4264 -14.7096 4.17994 -10.0586 +6515 4 22.0919 16.2116 19.4632 15.4216 -6.99735 9.66589 +6516 6 23.9693 21.8661 10.5894 -36.2244 3.36606 3.40233 +6517 4 22.9782 21.9097 10.6297 20.8239 3.29656 -5.85881 +6518 4 24.1356 21.2379 11.286 10.3432 -8.66819 12.8402 +6519 6 40.1777 25.441 2.79106 -10.2872 18.2283 6.37262 +6520 4 40.1705 25.0132 3.63888 8.49445 -17.5146 10.0011 +6521 4 39.7592 26.2809 3.01477 -1.02299 2.45309 -8.63041 +6522 6 15.0237 19.7749 9.41859 -29.0071 17.4399 5.80075 +6523 4 14.7228 20.7104 9.1599 7.38 -34.1593 9.70733 +6524 4 14.2459 19.2857 9.84339 25.5779 21.3804 -17.4983 +6525 6 7.16152 24.8628 0.123297 -7.02966 -3.56682 11.7049 +6526 4 7.96668 24.8036 41.5398 15.214 -7.46464 -23.6733 +6527 4 7.46323 25.2953 0.914133 -6.27594 4.44234 13.0485 +6528 6 43.3927 10.9201 31.3407 25.4071 10.106 7.84859 +6529 4 43.8098 10.8609 30.45 -7.40798 -0.791197 19.4909 +6530 4 44.1598 10.9733 31.9767 -21.009 -0.343387 -21.8186 +6531 6 13.8353 19.068 27.8558 -6.19586 12.3763 0.85665 +6532 4 12.975 18.7858 28.1864 -1.64107 2.23065 2.52451 +6533 4 13.8413 20.053 27.8412 2.88957 -13.8419 -2.19198 +6534 6 3.4728 19.5924 9.6022 -44.5705 9.69836 1.75794 +6535 4 2.70361 20.0095 10.0844 20.5969 -13.9146 -9.89239 +6536 4 4.25765 19.8234 10.0844 13.5534 0.0599395 5.99295 +6537 6 51.0213 19.4268 7.70955 2.43945 12.0622 -23.2725 +6538 4 50.6325 20.2627 7.28999 21.6228 -31.5555 10.1722 +6539 4 51.8004 19.115 7.16203 -27.7652 18.9123 7.69536 +6540 6 42.2139 2.59999 10.4154 11.3377 -7.01405 -0.847173 +6541 4 43.144 2.57533 10.7556 -19.516 1.89174 -10.2127 +6542 4 42.1979 2.39197 9.45142 9.27815 6.14572 20.7298 +6543 6 30.7794 6.42968 35.1975 -13.4378 -7.3385 -2.08895 +6544 4 29.8146 6.43175 35.3648 9.73054 -4.02703 -1.93701 +6545 4 31.052 5.50707 35.0427 -6.67101 6.52405 0.860042 +6546 6 52.8733 36.9495 18.5906 -4.95733 10.1612 -6.16245 +6547 4 51.9909 36.5548 18.5738 -2.549 -5.51132 1.40056 +6548 4 52.7192 37.8514 18.247 7.64894 -10.0112 4.74408 +6549 6 44.2058 6.2999 1.04709 5.21291 8.10008 11.2107 +6550 4 44.5368 6.97198 1.69742 -2.24215 -10.2401 -12.34 +6551 4 44.9393 6.09517 0.464894 1.54959 1.89788 1.1267 +6552 6 42.1369 38.61 31.1886 17.67 -9.24899 26.4806 +6553 4 41.7623 38.8803 30.3687 -14.3725 6.55505 -24.001 +6554 4 41.498 38.8614 31.8609 -3.32676 4.75778 -0.202389 +6555 6 43.7164 12.7972 9.05712 5.81528 3.72875 -30.711 +6556 4 43.3247 13.6946 8.89573 9.87346 -21.9812 3.16194 +6557 4 44.14 12.4709 8.19462 -12.6006 16.8915 32.7492 +6558 6 13.3844 0.443398 6.51083 -17.4423 24 5.83044 +6559 4 13.1471 1.18968 7.12521 11.9969 -17.0568 -16.1514 +6560 4 13.404 0.824606 5.60344 -0.330864 -2.32474 10.3957 +6561 6 16.1322 13.2809 10.2756 -7.67495 0.483234 -7.74316 +6562 4 16.9315 12.7781 10.4995 -2.28882 -8.98658 -2.43525 +6563 4 15.4389 12.669 9.92885 16.2568 3.72445 6.60733 +6564 6 1.59909 8.47465 4.69565 -12.106 -24.0688 17.9122 +6565 4 1.97809 9.06493 4.05503 13.7499 12.9224 -12.6029 +6566 4 2.17818 8.51684 5.47441 1.43398 4.73372 -5.14276 +6567 6 37.2847 1.71984 10.5234 11.0189 -27.5723 -13.4042 +6568 4 37.2468 2.67416 10.4778 -4.00861 9.27523 10.0347 +6569 4 36.8996 1.35439 11.335 -2.27729 16.2243 3.90618 +6570 6 53.8329 9.87891 17.6846 -38.3798 -30.924 7.14602 +6571 4 54.5301 10.0186 17.0634 18.0368 1.02749 -18.7159 +6572 4 53.3473 9.06138 17.3773 12.8854 20.2391 7.24153 +6573 6 45.4804 30.6107 15.8042 -8.04753 0.598448 7.23065 +6574 4 44.8245 31.2304 16.205 12.7241 -16.0174 -7.51778 +6575 4 45.2045 29.6903 15.9459 -0.384376 11.4708 0.631615 +6576 6 39.9212 16.643 33.8508 -27.7636 -7.17353 -19.4615 +6577 4 39.1766 17.1755 33.458 21.1378 -12.4278 10.7513 +6578 4 39.8244 15.7487 33.4296 5.23768 21.8708 14.061 +6579 6 32.8655 24.7639 27.9361 20.284 59.6053 -7.49862 +6580 4 33.6165 25.1458 28.4374 -8.60268 -19.6727 -0.650124 +6581 4 32.6313 25.5876 27.4183 -1.69816 -34.155 10.7383 +6582 6 7.87466 31.6143 24.1101 1.9117 20.6925 26.3443 +6583 4 7.66972 30.8573 24.7192 5.27436 26.873 -8.7819 +6584 4 7.9908 32.4716 24.6533 -12.57 -44.6195 -20.0842 +6585 6 43.5378 41.3358 15.8218 9.28004 -2.58796 -1.50951 +6586 4 43.1443 0.2957 15.6997 -2.19094 2.48586 -2.7957 +6587 4 44.4004 41.3722 15.3768 -7.99823 -0.449815 2.36698 +6588 6 20.0371 29.5453 33.205 3.08504 -20.5033 -11.6211 +6589 4 20.9096 29.2965 33.5637 -2.90058 10.2459 9.35691 +6590 4 19.6251 30.2513 33.706 8.84517 7.80605 8.87396 +6591 6 43.4117 21.4438 18.6347 -11.1342 -15.0059 14.8538 +6592 4 43.0276 21.2687 19.5098 8.56326 4.46648 -0.801958 +6593 4 42.8532 20.9111 18.0542 1.01153 2.95656 -9.2223 +6594 6 3.44653 19.1197 18.4217 23.6769 1.99723 9.81042 +6595 4 3.20802 20.045 18.3207 -2.32682 2.96104 -2.33529 +6596 4 2.63398 18.6303 18.3598 -12.7596 -8.76931 -2.32568 +6597 6 41.6678 38.1102 16.3244 12.531 -42.2252 -39.0953 +6598 4 41.9368 37.3879 15.641 -15.3799 38.9729 30.6603 +6599 4 42.3331 38.0554 17.0146 -0.0757724 1.18921 2.99625 +6600 6 7.55561 36.3978 10.4983 -3.44092 15.1931 -1.45671 +6601 4 6.72339 36.2337 10.0108 12.3142 -8.52859 4.51616 +6602 4 7.946 35.5335 10.7116 -10.6452 2.04557 -4.50299 +6603 6 36.2515 19.1074 34.8142 -43.7142 -17.0801 -27.3746 +6604 4 35.3817 19.3303 34.3863 23.1726 -6.06315 12.306 +6605 4 36.4633 19.8781 35.3097 10.3 22.3537 14.1292 +6606 6 53.5678 24.9372 12.6442 30.4342 18.5181 -32.2976 +6607 4 53.8348 25.8921 12.6266 -11.9077 -21.6197 10.5864 +6608 4 54.0165 24.5977 11.8224 -16.4724 -4.37861 26.9125 +6609 6 31.6766 10.443 21.0806 4.21881 -9.06253 -2.47208 +6610 4 31.4001 9.76622 21.7243 -7.70504 9.2495 -8.08332 +6611 4 30.9288 10.6617 20.4921 1.78432 -8.02731 8.28605 +6612 6 18.1094 28.7798 17.1891 14.7524 22.0605 -19.6834 +6613 4 19.0758 28.769 16.9872 -20.2742 -2.10771 9.28657 +6614 4 17.7731 29.5847 16.7123 5.43167 -23.0331 15.3038 +6615 6 21.675 18.2354 36.8765 16.12 -15.5286 8.52342 +6616 4 22.5529 17.9072 36.565 -22.4082 10.693 4.11156 +6617 4 21.5572 17.762 37.7329 -6.04816 8.67317 -10.9669 +6618 6 25.0658 19.0188 34.2159 -51.8076 2.97265 19.7815 +6619 4 24.747 18.4039 34.9114 5.38902 10.2451 -10.362 +6620 4 25.8774 18.6629 33.96 52.7001 -22.9877 -15.275 +6621 6 15.5692 13.0234 5.56242 -6.58245 2.44228 -13.4315 +6622 4 15.9945 13.4237 6.33643 -0.981395 -11.5063 2.18089 +6623 4 15.4281 12.0558 5.58603 5.20341 13.6823 8.40676 +6624 6 54.4716 41.6235 14.8012 14.2089 2.8312 2.80672 +6625 4 54.7869 41.5367 15.7234 -10.706 -4.16636 -8.71187 +6626 4 53.6678 41.1066 14.6963 -6.31993 -3.99892 7.53898 +6627 6 1.6781 26.4654 31.3743 5.67012 -21.4195 51.4057 +6628 4 2.55869 26.331 31.7713 -6.41431 -1.4007 -7.54986 +6629 4 1.81482 26.7235 30.4972 11.6805 15.9936 -52.9786 +6630 6 32.3382 37.285 29.6856 -26.7217 17.5069 7.43983 +6631 4 31.5807 37.8924 29.918 20.5429 -15.6126 -5.39856 +6632 4 33.128 37.6701 30.0913 2.74033 -1.11204 0.131524 +6633 6 52.7155 21.0369 22.8986 -26.6856 13.1044 -7.83906 +6634 4 51.927 21.5218 22.5308 17.9584 -10.8856 16.9396 +6635 4 53.1096 20.6236 22.131 10.0871 -9.76004 -3.40095 +6636 6 32.7546 28.5936 40.5151 -16.005 5.57574 20.6704 +6637 4 31.9696 29.0914 40.2712 1.08408 5.35728 -15.103 +6638 4 32.4826 28.2925 41.3957 13.2257 -7.23298 -6.66392 +6639 6 23.6064 32.0719 16.3529 6.2601 0.887785 0.577407 +6640 4 24.375 31.9361 16.9584 -22.6405 4.1158 -3.2487 +6641 4 22.7879 32.3052 16.8361 12.3926 -5.56708 -0.502672 +6642 6 37.5201 9.16809 29.9792 -2.73778 -7.47015 7.66604 +6643 4 36.7801 8.78215 30.4957 3.311 11.363 -11.2805 +6644 4 37.2059 9.98527 29.541 -5.1069 -9.85197 8.55889 +6645 6 2.27705 24.391 14.5477 -18.8311 -23.8216 -15.5117 +6646 4 1.75426 24.0938 15.3142 10.0576 11.8704 2.19803 +6647 4 1.95568 23.7778 13.8474 11.5886 17.7779 11.9828 +6648 6 27.3753 28.7961 24.7726 7.21008 -25.2057 -20.8265 +6649 4 27.1644 28.4274 25.6317 -2.92196 -0.0765173 10.3399 +6650 4 27.4291 28.0161 24.1505 1.02404 24.316 14.9 +6651 6 16.7879 2.56531 14.3086 11.9129 14.2285 -1.69346 +6652 4 17.7185 2.38196 14.3175 13.0278 5.32386 8.84309 +6653 4 16.4775 1.81817 13.8231 -22.7045 -15.6449 -12.1127 +6654 6 21.8022 39.8027 36.8001 40.4582 11.674 1.33338 +6655 4 22.755 39.5599 36.9347 -17 12.4394 -0.288792 +6656 4 21.461 38.9709 36.5396 -21.7153 -28.8447 -11.0269 +6657 6 14.0716 6.47232 41.542 21.0202 -14.2424 -6.97231 +6658 4 14.9696 6.10406 41.5939 -1.81915 -4.72532 -7.76656 +6659 4 14.0403 6.99701 0.421866 -13.8031 9.98176 13.4178 +6660 6 14.5555 16.5106 9.31543 20.3876 4.44524 4.12907 +6661 4 15.4025 16.5964 9.78828 0.864554 -6.42184 -12.9633 +6662 4 13.9847 17.046 9.86181 -12.8914 3.93145 3.80898 +6663 6 8.66171 23.4817 30.5575 -0.244333 -0.896371 32.8135 +6664 4 9.54353 23.6001 30.2398 18.7576 4.73722 -27.2602 +6665 4 8.85707 23.3999 31.5064 -16.6456 -3.41855 -0.290363 +6666 6 37.6497 2.07069 20.0046 29.2824 -26.1096 14.9164 +6667 4 37.0584 2.2163 19.2662 -13.6051 13.4744 -1.64318 +6668 4 37.4656 2.68422 20.7276 -9.488 6.31449 -9.7769 +6669 6 42.7264 7.54802 8.0174 22.2735 -23.3375 63.966 +6670 4 43.1898 7.96838 7.30926 14.9789 10.8108 -11.9713 +6671 4 43.3711 7.43923 8.8454 -34.4126 10.1207 -51.4479 +6672 6 38.5672 29.6578 6.85692 25.3422 5.29964 1.58487 +6673 4 38.5311 29.2984 7.75245 -9.71234 0.328663 -2.10015 +6674 4 37.7248 29.5682 6.41889 -15.2832 -4.18317 0.54199 +6675 6 42.5348 15.7114 39.7967 1.15785 13.3588 -25.5786 +6676 4 42.7129 16.6429 39.5831 1.88136 -1.51067 11.9166 +6677 4 42.2359 15.3735 38.9271 3.70013 -4.77916 17.2749 +6678 6 19.8546 7.43685 22.0566 -22.5975 2.81071 25.7956 +6679 4 19.2803 8.13273 21.6746 8.521 -7.13733 1.21439 +6680 4 19.4015 7.21173 22.9242 12.7412 8.86068 -31.9054 +6681 6 27.421 3.23371 12.5304 27.0524 21.0752 -24.489 +6682 4 28.3367 3.35644 12.1327 -27.9555 -7.8832 14.1518 +6683 4 27.3543 2.31638 12.8154 4.42645 -1.52034 -0.990676 +6684 6 34.4011 6.50186 34.3664 -16.3424 -2.90191 9.94761 +6685 4 33.6712 7.15225 34.4215 6.78416 -7.62851 1.00734 +6686 4 34.1394 5.7575 34.9538 2.66911 12.7001 -5.69623 +6687 6 9.88701 27.9536 39.7574 38.1218 -1.21446 9.36845 +6688 4 10.8313 27.9815 40.1009 -35.4969 -5.93471 -11.3457 +6689 4 9.7403 28.8357 39.397 -3.9481 4.17466 -3.11552 +6690 6 50.5681 22.1235 6.40489 -3.33101 1.51672 6.50125 +6691 4 51.5163 22.3536 6.46403 -14.0562 3.33212 10.0382 +6692 4 50.0608 22.5915 7.10741 15.6039 -2.37345 -9.267 +6693 6 47.1098 11.477 30.0359 32.4056 2.61276 18.961 +6694 4 47.3696 10.9259 30.8115 -10.3246 7.95021 -16.9085 +6695 4 46.3045 11.1726 29.6407 -20.48 -14.5539 -1.24473 +6696 6 25.9367 28.4654 9.80931 -8.38409 -27.2904 31.5361 +6697 4 26.8395 28.2564 10.1264 -14.1867 1.81997 -4.27567 +6698 4 25.3175 27.9176 10.3882 19.4096 21.4407 -17.1039 +6699 6 35.4417 36.6052 19.4431 3.65383 9.51374 12.5698 +6700 4 35.4442 36.5892 20.4356 4.35023 4.13201 -20.4161 +6701 4 36.0823 37.2978 19.1702 -7.18083 -5.57131 7.61291 +6702 6 39.0947 17.861 12.3005 -1.37104 18.7141 6.38745 +6703 4 39.0516 18.8013 12.5757 6.4741 -5.57949 -8.41576 +6704 4 38.3925 17.481 12.8252 -9.64523 -10.3587 5.73293 +6705 6 2.67895 27.1328 2.39169 -0.469231 -1.96621 -7.87892 +6706 4 2.01695 27.5866 1.84113 6.06579 -3.44887 4.00529 +6707 4 2.54603 27.3828 3.31988 1.36543 -1.57126 -4.01383 +6708 6 12.3125 32.2183 21.5204 7.73608 31.3279 -34.5621 +6709 4 12.8754 32.1648 22.302 -15.5368 -9.13091 6.69049 +6710 4 11.4514 31.7997 21.5885 -0.151568 -8.94455 23.3893 +6711 6 32.8824 32.3641 8.46179 -18.8611 4.30442 3.1153 +6712 4 33.4241 32.9657 8.96292 17.2175 7.79223 5.74753 +6713 4 32.0088 32.7748 8.50666 0.635289 -6.40729 -7.5616 +6714 6 12.649 6.44414 31.9754 -2.83404 4.50046 10.0363 +6715 4 13.204 6.32185 31.2101 8.19857 -2.9014 -11.0209 +6716 4 11.7563 6.235 31.704 -2.09981 -3.08597 -3.85403 +6717 6 41.3663 27.7408 14.044 -7.1512 -14.0341 -18.9391 +6718 4 41.8178 27.3798 13.2339 -12.2472 13.3456 19.5442 +6719 4 40.4043 27.5413 13.9741 19.5004 0.843126 1.31278 +6720 6 6.61204 16.505 25.4358 4.38086 10.1107 -4.22872 +6721 4 7.40634 15.95 25.3995 -3.52048 -0.326181 -5.74655 +6722 4 5.93615 16.0015 24.9584 5.4209 -2.01242 3.85811 +6723 6 21.7595 39.2992 13.3504 -47.5104 6.20728 42.9111 +6724 4 22.3466 39.2605 12.6295 26.4998 6.28224 -34.1528 +6725 4 21.7095 40.2078 13.7281 10.6984 -16.5323 -14.9329 +6726 6 34.8487 6.01484 6.95222 -29.6963 0.326386 -14.1862 +6727 4 33.862 5.88861 6.88689 25.1099 2.0969 11.0318 +6728 4 35.0754 6.24807 6.0365 6.49139 -1.48305 5.74594 +6729 6 33.0274 30.4243 33.1708 -20.2868 -13.6057 -33.0226 +6730 4 32.107 30.5622 32.8069 24.6222 -1.48625 15.7647 +6731 4 33.1252 31.0225 33.8918 -2.19017 18.1524 16.6028 +6732 6 15.459 32.4153 12.1907 25.026 -14.7999 12.6103 +6733 4 16.3707 32.0454 12.2858 -22.5133 7.43237 -2.39957 +6734 4 15.4871 32.8857 11.3664 4.63911 10.1509 -16.175 +6735 6 12.6896 26.6018 21.3639 -15.0944 -25.6853 -2.70918 +6736 4 11.948 26.0906 21.6799 0.937138 -29.673 -19.3981 +6737 4 12.542 27.2759 21.9777 19.0907 58.813 21.5342 +6738 6 47.0229 36.3064 29.9951 -7.32095 -4.41829 24.4392 +6739 4 47.4263 37.0889 30.4354 -10.9743 -13.05 -1.23566 +6740 4 46.4286 35.8162 30.6445 23.161 23.2616 -16.2608 +6741 6 0.29284 12.714 23.4069 -35.5625 7.7859 6.41586 +6742 4 0.591011 11.8915 23 -3.04289 0.952694 -0.179009 +6743 4 54.2726 12.6526 23.4069 36.7156 0.482893 -0.227565 +6744 6 54.1717 18.9252 21.5683 -50.0663 20.0699 0.290361 +6745 4 -0.00468748 18.6783 21.9698 30.2345 -16.5238 -1.58257 +6746 4 54.0846 18.73 20.626 15.626 -5.42297 0.74208 +6747 6 25.7258 24.2992 23.7444 19.803 -45.4072 -0.235584 +6748 4 25.1532 23.5493 23.4006 14.0979 28.9064 13.4272 +6749 4 26.557 23.8171 24.0636 -29.432 23.3848 -10.2309 +6750 6 11.8983 29.0288 26.8736 6.09277 -0.515715 3.71925 +6751 4 12.595 29.6797 27.0784 -3.35093 -5.68029 1.25498 +6752 4 11.9864 28.3255 27.5444 1.01315 10.8055 -7.75858 +6753 6 47.9911 35.8567 10.6981 8.08413 -4.02984 -21.6227 +6754 4 48.7745 35.7734 10.1229 -13.6418 -1.85084 -2.1863 +6755 4 48.3792 36.2903 11.4463 -1.30569 7.34959 21.4512 +6756 6 47.672 29.8438 36.9511 38.562 -32.0587 -16.7646 +6757 4 48.1514 29.311 36.2244 -26.8687 25.3781 26.6073 +6758 4 46.9232 30.3209 36.5927 -0.690739 -0.634879 -8.58348 +6759 6 7.33835 12.3416 10.615 -8.89583 -3.33234 -10.1121 +6760 4 7.22469 12.7824 9.73793 -1.24183 -8.23722 19.221 +6761 4 6.50851 12.5236 11.1156 17.4449 -0.896679 -14.5349 +6762 6 52.929 15.961 4.90278 -10.2898 -1.28264 -8.50781 +6763 4 53.0348 16.1145 3.95774 -1.18717 -0.815743 4.35872 +6764 4 53.806 16.0238 5.26597 15.814 -0.370642 9.21047 +6765 6 10.6777 16.9586 34.6035 -55.1347 -38.7426 5.67968 +6766 4 10.8984 16.7766 35.5088 23.7364 14.024 15.8473 +6767 4 9.8802 16.3472 34.5582 30.0556 27.9196 -18.3163 +6768 6 25.1377 31.056 36.0048 1.42921 -10.848 -28.6765 +6769 4 25.7744 31.7772 36.0714 -0.417948 1.95283 3.18329 +6770 4 25.3475 30.6244 35.1463 -8.66047 8.51414 18.9355 +6771 6 34.0941 21.8921 41.4705 -2.59948 8.49748 21.8065 +6772 4 33.8376 21.0023 41.2487 -0.891159 -17.6747 -3.00217 +6773 4 34.5263 22.2081 40.6953 10.3371 11.5397 -24.1167 +6774 6 15.7674 30.0637 1.25444 19.4532 4.17941 -23.0135 +6775 4 15.204 30.4318 1.91689 -16.4157 4.77211 21.8875 +6776 4 16.1981 30.8773 0.915598 -5.77798 -19.2538 1.08217 +6777 6 29.5177 27.8662 16.6069 -21.9867 -20.8772 26.8051 +6778 4 29.4575 26.8938 16.8925 2.72258 42.9501 -5.19299 +6779 4 28.8337 28.3532 17.1557 16.905 -14.8206 -13.8895 +6780 6 39.6418 9.77683 0.55649 6.97543 15.8838 23.3716 +6781 4 40.1108 10.6055 0.868863 -11.4024 -23.0197 -7.66085 +6782 4 39.4946 9.23542 1.36828 3.21978 8.9832 -14.2415 +6783 6 1.52158 31.8692 16.4183 -13.8984 7.04184 27.8471 +6784 4 2.05742 32.2974 15.7673 16.5414 8.9668 -16.2997 +6785 4 1.54493 30.9444 16.2035 3.31157 -20.7597 -8.56027 +6786 6 8.73651 39.8559 25.0424 -4.76165 -15.5453 0.0774869 +6787 4 8.05377 39.648 25.6948 0.177415 -5.7342 -2.33302 +6788 4 8.86744 40.7877 25.1714 9.39418 20.2019 -3.50565 +6789 6 42.3206 10.2864 9.76098 2.95973 19.1246 -1.63703 +6790 4 42.201 10.133 10.7061 4.21692 -0.996774 -0.328573 +6791 4 42.7677 11.1578 9.6855 -5.09192 -13.1904 -0.0451331 +6792 6 13.2407 7.61713 1.96996 -7.39862 -1.41628 8.88927 +6793 4 13.9913 7.91748 2.51852 -7.45732 -2.50241 0.703823 +6794 4 12.5579 7.21318 2.54911 15.3337 9.06064 -6.21655 +6795 6 18.7418 40.0591 14.2229 14.6643 6.60726 6.61579 +6796 4 19.3344 39.8885 14.9901 -13.3575 3.17545 -12.3588 +6797 4 17.9636 39.4956 14.2872 3.6042 -5.87931 7.54738 +6798 6 20.1073 14.0529 38.5598 27.8117 -61.2518 1.76132 +6799 4 20.1641 13.6472 37.6602 -4.05869 13.902 17.7453 +6800 4 19.784 14.907 38.4293 -21.3136 56.4597 -12.4562 +6801 6 22.6529 28.8869 34.0687 6.58134 -12.6264 20.4136 +6802 4 23.051 28.2341 33.486 -0.980474 2.102 -8.59088 +6803 4 22.967 28.5961 34.9503 -6.50134 7.38476 -6.63172 +6804 6 22.6736 4.71248 5.24178 -0.00794307 -2.96021 -16.86 +6805 4 22.1728 3.90748 5.48978 2.26378 16.1145 9.27739 +6806 4 22.7088 5.35566 5.95806 -4.05577 -5.29394 11.9552 +6807 6 23.6374 34.0001 38.3917 50.061 26.1352 -20.3518 +6808 4 22.8137 33.6238 38.6177 -41.7704 -11.5062 -0.965889 +6809 4 23.6153 34.3835 37.4812 -9.56218 -11.3792 16.4738 +6810 6 48.3816 21.3644 17.2759 -0.964958 21.4078 15.1884 +6811 4 48.1603 22.346 17.2347 5.31328 -30.3781 -7.15015 +6812 4 48.2799 20.9337 16.4123 -2.86285 15.3202 1.32987 +6813 6 11.5786 11.0066 8.63803 -22.8025 30.9503 41.2381 +6814 4 11.6342 10.2487 9.24135 6.24209 -4.12245 -6.65597 +6815 4 11.0653 11.6976 9.17674 20.0011 -23.9124 -25.5895 +6816 6 40.098 28.1667 33.502 25.4322 5.13826 0.328547 +6817 4 41.0532 28.3457 33.4282 -8.43417 -7.39989 8.78785 +6818 4 39.8078 28.5143 32.6608 -12.8477 1.2165 -2.93222 +6819 6 47.3852 25.6796 5.28879 12.5804 32.9376 -10.0311 +6820 4 46.4546 25.5561 5.13624 -16.8804 -10.2001 -0.268496 +6821 4 47.5232 26.6241 5.03253 2.87445 -14.5067 3.75712 +6822 6 21.6604 35.221 23.9985 9.0652 15.9564 -12.6156 +6823 4 21.5339 34.4977 24.6161 5.50034 -7.33202 6.93593 +6824 4 22.5891 35.5406 24.0132 -10.9025 -9.97729 6.37443 +6825 6 8.25067 41.5023 8.40693 4.57396 0.593767 -7.67714 +6826 4 8.14583 40.8128 7.73311 1.23406 2.32353 -0.157563 +6827 4 7.86929 41.1416 9.20784 -2.18245 3.41182 6.12515 +6828 6 16.4756 31.0916 22.2208 -15.8048 -5.76047 -3.57767 +6829 4 16.9823 30.8797 21.4186 0.224111 -1.11381 3.57708 +6830 4 17.0871 31.1495 22.9566 10.3822 -1.94934 1.40451 +6831 6 54.7052 0.441622 28.3216 30.4392 7.42547 7.16367 +6832 4 0.670225 0.280878 28.2941 -2.60978 -25.0778 -11.1355 +6833 4 54.7831 1.35385 28.5964 -22.0828 12.0381 3.63841 +6834 6 48.4365 15.3814 4.18175 16.1137 -59.8395 -8.29881 +6835 4 49.2486 15.0627 4.66696 -19.7577 20.5705 -9.22457 +6836 4 48.202 14.5739 3.61717 1.65501 39.0327 16.4105 +6837 6 34.3447 6.98096 40.4233 28.1894 -26.1309 -0.966046 +6838 4 33.5941 7.1072 39.8443 -1.28272 -2.58724 -7.46065 +6839 4 35.0352 6.39393 39.9745 -30.768 20.5054 8.50532 +6840 6 41.3452 3.36617 16.9999 -11.8967 -16.9054 2.63506 +6841 4 41.0249 2.72492 17.6694 2.1854 6.18106 -7.89089 +6842 4 41.9449 3.92974 17.49 7.08552 9.22633 4.28017 +6843 6 48.4488 20.6937 14.5344 36.1561 -40.2628 27.2518 +6844 4 47.9962 21.3635 14.0898 -25.7182 45.1623 -29.349 +6845 4 49.3977 20.8911 14.4834 -7.22111 0.680744 -3.09477 +6846 6 52.5006 28.1422 37.1181 -0.438891 10.9489 1.55023 +6847 4 53.461 28.2559 37.0441 -2.53591 -5.73983 -7.32344 +6848 4 52.1579 27.9957 36.2188 6.05301 2.29627 6.02383 +6849 6 53.8778 18.5596 18.7916 -16.4261 -54.6782 2.06415 +6850 4 54.6924 18.1462 18.492 5.89253 -2.608 -0.931268 +6851 4 54.0684 19.4623 18.7843 11.279 55.5152 0.463912 +6852 6 40.9954 39.1455 28.7887 -28.6383 -4.85259 53.4888 +6853 4 41.3933 39.2419 27.9663 30.849 7.00679 -57.5311 +6854 4 40.0484 39.2316 28.6375 -4.32997 -1.25138 -0.266272 +6855 6 38.2708 8.75593 24.2289 27.2886 -4.9888 -5.43324 +6856 4 39.2171 8.59021 23.9715 -26.3742 3.09491 7.04217 +6857 4 38.3303 9.34105 24.9905 -3.83131 2.71498 5.53525 +6858 6 2.99948 29.1469 9.63392 26.6909 -34.1608 2.5373 +6859 4 2.51216 28.7995 8.89273 -4.75194 -2.8028 -9.24178 +6860 4 2.58111 29.9575 9.82954 -15.8869 33.6035 13.3424 +6861 6 27.5773 29.2771 18.3181 4.27818 -11.5166 33.1226 +6862 4 26.7531 29.1546 17.8331 -9.3021 -0.872639 -4.78576 +6863 4 27.3558 28.9731 19.2647 9.0806 12.9475 -44.783 +6864 6 11.8527 21.1658 10.1208 3.44892 -32.1211 19.512 +6865 4 12.1978 22.0146 9.89711 8.39983 22.4635 -8.03232 +6866 4 12.4593 20.8304 10.8135 -12.0936 9.66798 -13.0295 +6867 6 16.8988 32.3014 0.299949 1.29982 1.68058 -0.586211 +6868 4 17.7043 32.7282 0.600499 13.9817 -1.747 3.00212 +6869 4 16.3216 33.0562 0.17902 -12.1561 7.80428 -5.7129 +6870 6 1.309 17.4831 22.5447 23.3848 -11.3219 -15.6007 +6871 4 1.13597 16.5744 22.1718 3.15619 19.2398 8.80125 +6872 4 2.27868 17.6899 22.4311 -25.7511 -7.40397 3.71946 +6873 6 41.5587 6.87311 29.3039 4.08196 29.5448 1.53382 +6874 4 41.6919 5.95311 29.5356 2.80206 -5.98386 3.69024 +6875 4 41.9106 7.40602 30.0483 -3.99043 -10.4039 -5.51054 +6876 6 10.5167 10.7886 13.8618 17.7458 -17.1897 13.2051 +6877 4 10.6632 11.2096 13.003 1.79898 0.261401 -4.84225 +6878 4 11.2159 10.1 14.0373 -16.1376 17.4326 -7.31573 +6879 6 39.8332 15.4952 40.8309 13.3581 4.75609 3.89566 +6880 4 39.9392 16.0809 40.0548 0.3292 -3.56753 7.15077 +6881 4 40.6564 15.5643 41.3732 -15.0531 5.58747 -11.8726 +6882 6 26.5094 19.6057 40.5003 9.17758 -2.41024 9.24949 +6883 4 27.4312 19.885 40.5187 -1.32295 2.31326 -8.74715 +6884 4 26.4504 19.08 41.3172 -10.7617 -0.025449 -2.36491 +6885 6 54.0331 8.19348 13.7645 20.1265 23.4755 -3.20859 +6886 4 54.5379 7.42769 14.0195 10.1236 -9.46733 3.3174 +6887 4 53.1635 7.89609 13.5919 -33.2862 -9.18344 -4.84573 +6888 6 15.685 25.3343 10.6639 3.77823 -5.01457 0.699023 +6889 4 15.2925 25.3549 9.7704 -6.94194 -0.507815 8.78718 +6890 4 14.9859 25.2981 11.3464 3.26271 -0.250944 -15.837 +6891 6 18.6044 3.42728 21.9359 54.0117 -4.17358 13.1129 +6892 4 19.6007 3.50499 22.1915 -55.8621 -1.2706 -18.0159 +6893 4 18.5414 3.70523 21.0018 -0.6471 0.781857 10.4283 +6894 6 50.8906 20.6382 18.514 19.322 19.8933 14.7131 +6895 4 50.0771 21.0514 18.1693 2.40506 3.30677 2.13188 +6896 4 51.4314 21.2881 19.0676 -26.3068 -18.4046 -20.3942 +6897 6 53.3692 20.9044 31.2861 -2.87581 -0.0590227 -4.61483 +6898 4 53.3163 20.8663 32.2507 -1.10677 -1.05899 -2.14121 +6899 4 52.4655 20.8115 30.924 8.48272 0.484508 7.85381 +6900 6 52.8175 27.637 28.9992 -34.1073 -16.3293 -5.23745 +6901 4 52.1753 27.4604 29.7292 18.9476 13.4611 -8.14668 +6902 4 53.5412 28.184 29.256 17.7352 16.912 19.7012 +6903 6 33.3098 15.691 11.3293 10.3241 5.44869 29.2776 +6904 4 33.5439 15.9761 12.2647 -8.49351 -12.0766 -30.078 +6905 4 32.4682 16.1118 11.1139 -1.38634 1.49203 3.14806 +6906 6 20.3823 26.792 27.4754 10.6616 14.7237 17.2289 +6907 4 19.6846 27.4135 27.2507 -4.69437 -0.849554 -6.03625 +6908 4 20.895 27.2908 28.1563 -10.3656 -18.3754 -15.2612 +6909 6 8.54404 2.05454 14.1651 1.1449 13.7122 2.29602 +6910 4 8.12946 1.19872 14.2191 -6.02545 -13.9865 0.607463 +6911 4 8.06484 2.58201 14.8308 4.74922 -3.38849 -5.44478 +6912 6 40.1105 7.56396 40.6794 -0.469697 6.72942 -1.63666 +6913 4 39.7195 8.28533 41.2425 20.0171 -18.0739 -7.27063 +6914 4 40.8018 7.03949 41.1472 -13.6242 13.5344 3.71207 +6915 6 6.897 6.83213 10.7811 7.71606 15.0782 -3.77655 +6916 4 7.19774 7.75246 10.6132 -6.74961 -17.2243 4.00207 +6917 4 7.00156 6.6927 11.7358 -2.06706 0.697676 -4.80225 +6918 6 31.2469 6.57665 20.133 15.2512 -44.8317 5.05575 +6919 4 30.6435 5.99888 20.634 -3.65198 3.16249 1.16613 +6920 4 30.7682 7.35458 19.9689 -22.0921 35.6742 -6.0398 +6921 6 54.5384 21.0446 27.3066 23.2273 -48.3206 40.5729 +6922 4 0.0992734 20.2122 27.4067 -21.2046 24.987 7.15799 +6923 4 54.6588 21.2398 26.4073 -2.82622 20.9035 -45.5707 +6924 6 4.74298 23.1434 16.2203 -30.2995 19.4891 -12.6787 +6925 4 4.36556 24.0555 16.215 7.46998 -18.526 0.357752 +6926 4 5.49124 23.2367 16.7883 23.1348 -5.45784 14.6166 +6927 6 25.5466 11.0338 14.8277 10.3359 0.700294 4.3384 +6928 4 26.1246 10.3443 15.2243 -8.70528 11.4294 -11.7317 +6929 4 25.9183 11.8873 15.0941 -0.865353 -5.34287 -3.41216 +6930 6 41.1962 41.784 29.9422 -30.017 -5.50367 -10.8152 +6931 4 40.9141 40.905 29.5845 10.5201 22.1914 8.67773 +6932 4 40.3904 0.453034 29.9085 19.4524 -11.6054 2.3136 +6933 6 52.2783 15.2862 41.6211 7.07203 -4.19206 -10.8941 +6934 4 51.9431 15.9476 0.307056 -1.67854 11.1856 8.97788 +6935 4 51.5699 14.6487 41.5543 -8.05659 -11.9472 -4.98288 +6936 6 37.758 21.7866 37.8526 10.4754 12.291 4.40187 +6937 4 37.8833 20.8525 37.7239 2.64231 -18.5298 -3.43162 +6938 4 38.1062 21.9123 38.7409 -0.189838 4.59809 2.45253 +6939 6 23.846 9.72877 27.5599 -20.0483 -53.0743 -18.3837 +6940 4 23.7508 8.9538 26.878 9.78252 41.145 35.6193 +6941 4 23.2758 9.50619 28.3397 9.82275 7.24107 -18.911 +6942 6 43.0179 28.0371 32.8168 -8.27592 12.0689 -0.875134 +6943 4 42.8326 27.1827 33.2413 14.9994 1.75302 -2.99965 +6944 4 43.9358 28.1723 32.5349 -8.32605 -13.2452 6.20231 +6945 6 34.1493 21.223 11.895 -6.4617 -26.4803 6.62596 +6946 4 33.7114 20.3967 12.2433 5.74917 23.5867 -12.2191 +6947 4 33.6625 21.5015 11.0997 -1.34318 -2.64619 5.02085 +6948 6 10.5048 31.8203 10.0934 3.12763 27.8567 -5.97475 +6949 4 10.8893 32.6663 10.3856 -2.25958 -16.5293 2.97323 +6950 4 10.042 32.0955 9.27903 1.62317 -10.8132 6.61598 +6951 6 35.8582 37.1311 22.1219 17.442 6.8165 -15.3109 +6952 4 36.7754 37.4644 22.0121 -13.2022 -8.29883 -6.66499 +6953 4 35.6795 37.2674 23.0383 -11.5038 0.0185045 25.2366 +6954 6 27.2889 4.59659 27.4585 -59.4895 -12.2555 32.2126 +6955 4 27.8503 4.63259 28.2407 7.94553 1.46958 -1.61102 +6956 4 26.3513 4.38137 27.8533 49.6255 8.2673 -26.6042 +6957 6 39.0071 22.2889 10.6559 -18.7539 6.55471 8.53947 +6958 4 39.6145 22.0219 9.97399 11.0637 -4.63202 -10.5583 +6959 4 38.132 22.2267 10.2407 1.98377 -6.13574 3.6668 +6960 6 30.7475 39.195 10.9378 13.4076 -25.4475 -2.13886 +6961 4 31.7135 39.1987 10.9202 1.84768 25.2682 1.10777 +6962 4 30.6542 38.2342 10.8274 -15.9936 9.0572 -1.5893 +6963 6 44.6038 26.9469 2.19596 -3.02312 -2.7981 0.496435 +6964 4 44.789 26.0668 2.58199 4.34993 15.1048 -14.5643 +6965 4 45.3477 27.2287 1.63769 1.54159 -5.20589 8.29494 +6966 6 23.7761 14.5574 26.4892 -1.60295 28.5342 -20.4107 +6967 4 23.6176 15.1119 25.659 4.49284 -25.3407 28.839 +6968 4 23.2395 13.7622 26.4238 -2.18231 -2.53609 -2.40557 +6969 6 38.3444 13.3746 39.6516 36.4054 -1.80378 3.51049 +6970 4 39.1202 13.8805 40.0461 -33.1028 -11.4882 -12.1373 +6971 4 37.5326 13.855 39.8351 -2.35218 5.60767 6.28087 +6972 6 17.8972 17.2344 29.4073 9.50877 -9.96512 10.1834 +6973 4 17.6974 16.8197 28.5593 -3.90288 0.722299 -3.3346 +6974 4 17.259 17.9348 29.5179 -13.7448 8.39178 0.729907 +6975 6 17.4263 29.84 9.91085 4.63967 13.4244 18.4952 +6976 4 16.5241 29.7155 9.63978 -6.68442 -7.79832 -10.641 +6977 4 18.0121 29.6473 9.18714 6.17675 -5.88453 -9.84082 +6978 6 35.6257 6.05657 19.614 -2.53427 -7.67526 1.74575 +6979 4 35.1442 5.56448 18.9178 7.07991 15.7277 0.668344 +6980 4 35.8526 6.94177 19.2847 -2.44106 -6.98166 -5.33042 +6981 6 18.6731 22.2952 17.5195 -8.35574 4.99894 -0.254983 +6982 4 17.7298 22.4259 17.6349 -7.1371 0.699885 10.6378 +6983 4 18.7532 22.3981 16.578 9.97204 2.32932 -16.3296 +6984 6 20.0126 3.82895 32.2846 -5.38506 7.6032 10.998 +6985 4 19.7316 4.05659 31.3951 3.95105 0.959407 -6.40709 +6986 4 20.9087 3.45699 32.2166 -3.62371 1.18893 -2.87546 +6987 6 5.48106 6.97474 8.11911 -13.3431 -28.5569 -4.23146 +6988 4 5.76723 7.87539 8.05126 9.5873 19.9723 5.64469 +6989 4 5.84003 6.56862 8.91875 4.365 4.20298 7.41399 +6990 6 44.2055 20.527 25.594 -36.5422 -32.7496 -22.1294 +6991 4 44.4952 21.1964 26.2048 27.2712 12.1663 0.509182 +6992 4 44.8136 20.1687 24.9192 13.264 16.717 13.5958 +6993 6 43.9676 36.9898 17.8707 9.43563 13.9581 11.3899 +6994 4 44.6425 37.4866 17.3506 -13.9886 -14.2814 1.04264 +6995 4 43.5166 36.316 17.3518 1.57776 -4.71986 -9.07493 +6996 6 34.624 10.1249 16.2553 -3.80507 -0.870494 -23.8528 +6997 4 34.4029 10.0232 15.2766 7.60873 7.05542 33.3523 +6998 4 34.6485 11.0843 16.4397 0.136369 -4.79707 -6.11079 +6999 6 23.6588 3.43472 1.31587 2.0947 2.20184 -10.1691 +7000 4 23.5283 2.45383 1.23665 3.68597 29.2686 -10.0862 +7001 4 23.7829 3.95594 0.465507 -5.48879 -27.0668 21.3429 +7002 6 33.408 38.9514 5.0951 12.9752 29.4037 8.61745 +7003 4 33.0296 38.079 4.95882 -18.4714 -2.71742 3.9597 +7004 4 32.7559 39.6696 5.33685 4.56028 -29.4715 -9.24259 +7005 6 22.5612 32.5054 35.7914 -7.59797 17.3543 -6.08959 +7006 4 23.434 32.1498 35.9581 8.59623 -0.183209 1.98348 +7007 4 22.6598 33.4814 35.6698 2.01652 -18.126 2.22848 +7008 6 32.4197 37.2669 13.8205 20.7322 22.1346 -9.91782 +7009 4 31.6112 36.8955 13.5272 -29.3682 -10.7083 -8.61391 +7010 4 32.7793 36.5983 14.3861 8.71878 -17.2052 10.8721 +7011 6 52.6061 12.7509 39.5955 -8.08982 -5.36768 -0.728302 +7012 4 53.2357 13.3696 39.2333 6.80499 9.05338 -6.44134 +7013 4 53.0752 12.2813 40.2869 4.34006 -2.9945 3.85342 +7014 6 28.8406 14.5639 1.22393 13.2702 13.2594 -7.07732 +7015 4 28.2547 13.832 1.29641 -8.98786 -23.9917 -3.18497 +7016 4 28.3081 15.2705 1.57856 0.691728 8.20301 3.76967 +7017 6 1.46371 32.4171 23.3808 -12.1734 -25.5645 13.9938 +7018 4 1.52421 31.5049 23.0145 7.51613 19.861 -1.66683 +7019 4 1.90409 33.05 22.8306 10.4998 5.06095 -20.3958 +7020 6 54.3326 23.3294 28.9734 2.61182 15.3833 -1.51239 +7021 4 54.2696 22.9227 29.8387 -0.130455 -4.55084 5.05008 +7022 4 54.4476 22.6226 28.3359 -0.0534198 -9.82677 -0.516761 +7023 6 14.3165 12.143 35.6759 -19.2415 -8.81627 -0.503167 +7024 4 14.3877 12.7977 36.3527 0.233596 18.6669 11.2481 +7025 4 15.2077 11.8775 35.5438 25.0768 -7.98239 -7.51161 +7026 6 18.9926 6.51479 41.2701 -28.9824 -29.6237 1.81046 +7027 4 18.266 5.84223 41.3522 13.7729 17.3268 -5.20094 +7028 4 19.3309 6.57432 0.258232 8.64619 7.1183 4.95474 +7029 6 5.3156 17.8978 20.3375 -21.1545 16.5991 3.60383 +7030 4 4.72623 18.3448 19.6879 4.29754 -5.05212 8.41069 +7031 4 4.82948 17.9368 21.1935 9.1049 1.98802 -15.8618 +7032 6 24.7216 34.9676 30.1666 -3.07326 -14.2394 -14.8574 +7033 4 24.8542 35.9126 30.1802 4.14387 12.0412 4.3338 +7034 4 24.7023 34.7085 29.2239 -0.0690866 8.67132 12.606 +7035 6 31.8759 4.61762 18.1838 16.2734 -6.94643 -1.61547 +7036 4 31.7767 5.32612 18.8146 -0.693712 9.66586 8.6442 +7037 4 30.9961 4.53608 17.8264 -12.7431 -2.99311 -6.3499 +7038 6 8.70679 17.4876 5.93376 -7.2594 15.0659 3.57914 +7039 4 7.94553 18.1226 5.84491 19.4684 -9.25267 2.2845 +7040 4 9.55198 17.9922 5.98984 -15.4384 -2.82622 -0.0668602 +7041 6 29.8338 10.9771 14.4736 2.85583 -20.8689 4.17621 +7042 4 29.3487 11.4359 13.7779 -2.35633 12.0716 2.99849 +7043 4 29.9333 11.5067 15.2792 -5.11986 9.15119 -1.36774 +7044 6 48.7176 10.2992 32.5766 37.752 -4.2965 -7.5649 +7045 4 48.6861 9.98692 33.5109 4.36425 8.41374 -15.5521 +7046 4 49.6689 10.1741 32.2115 -43.6207 3.75412 17.6406 +7047 6 8.33261 15.6868 37.8739 25.2856 -16.7599 -34.932 +7048 4 8.10095 16.0156 38.719 -17.2941 17.7495 29.2541 +7049 4 7.84865 16.1686 37.1872 -4.77393 6.83012 10.4818 +7050 6 50.4 3.07893 17.326 6.75193 2.54677 -10.5223 +7051 4 49.8476 3.08454 16.5614 0.0537611 0.514048 -24.7797 +7052 4 49.7563 3.22783 17.9993 -5.52918 6.4504 35.6689 +7053 6 14.6925 38.3995 10.8943 -10.4545 -11.2686 -1.07851 +7054 4 14.3539 38.6226 11.7634 0.533319 14.8424 10.3104 +7055 4 14.2274 37.5681 10.7419 5.82896 -0.087222 -8.72758 +7056 6 34.1157 6.37736 10.827 20.4112 17.5403 9.63945 +7057 4 34.1356 7.15575 10.2337 -4.79421 -13.4894 2.09643 +7058 4 34.9392 6.47467 11.3721 -17.4677 -2.57189 -8.67394 +7059 6 7.16428 37.5549 17.6272 35.8206 -6.94283 1.42456 +7060 4 8.17672 37.4379 17.5039 -45.4701 3.04153 9.54579 +7061 4 6.9329 37.0909 18.4673 4.48983 7.2965 -12.9876 +7062 6 51.5173 11.3068 16.7982 -29.6345 12.4732 -19.9425 +7063 4 52.2329 10.8476 17.1999 24.0623 -16.8016 7.00331 +7064 4 51.4947 11.1437 15.8343 5.46468 -1.37513 9.57578 +7065 6 15.6604 8.64432 3.1895 3.55656 -13.2601 -18.336 +7066 4 15.3831 9.26805 3.84437 -11.3932 20.6181 15.5674 +7067 4 16.2117 8.03967 3.68493 6.317 -8.49687 -0.892024 +7068 6 5.4241 21.4549 11.925 7.11554 10.6798 -7.02681 +7069 4 5.33432 22.3429 11.4717 -4.65036 -17.889 17.4658 +7070 4 4.77116 21.2815 12.6313 -0.367847 15.68 -7.67111 +7071 6 50.1893 24.0442 37.9781 -13.1484 0.855785 -17.0816 +7072 4 49.5179 24.1845 37.2801 8.13829 0.111989 16.6227 +7073 4 50.739 23.3224 37.6715 2.2014 -1.01472 3.1635 +7074 6 39.7382 11.2507 31.6977 23.6406 7.23187 -3.58891 +7075 4 40.4046 11.8538 31.2923 -18.8268 -10.2166 5.80002 +7076 4 38.8713 11.6238 31.5229 -1.54541 8.70996 -4.13134 +7077 6 26.6923 10.8294 20.5841 1.50171 17.3672 -0.163562 +7078 4 26.3063 11.3901 21.299 5.00814 -17.7696 -11.6362 +7079 4 26.5519 9.91114 20.8376 -1.99146 -0.979444 5.82041 +7080 6 12.5744 17.5779 18.1705 9.62673 -31.396 -11.9521 +7081 4 12.2909 16.663 17.987 19.11 1.74385 -8.92353 +7082 4 11.8345 17.8227 18.6757 -30.0259 29.7826 25.4081 +7083 6 47.7778 31.6094 17.3292 -7.10666 -17.038 -8.06235 +7084 4 48.347 31.2547 18.014 2.28217 1.30733 4.94459 +7085 4 47.3418 30.8212 16.9416 1.10301 17.3121 -1.07651 +7086 6 1.06524 3.39018 18.5298 -14.3894 10.3619 10.5476 +7087 4 1.40487 3.81402 19.3241 14.4239 4.64695 -0.395869 +7088 4 0.13491 3.28998 18.7837 -2.56119 -4.67364 -10.5163 +7089 6 26.5953 20.387 15.3121 4.86749 -24.5982 -5.101 +7090 4 27.0693 19.5476 15.0746 -6.18915 17.8108 6.48343 +7091 4 25.6882 20.059 15.4501 7.15985 4.40883 -1.86988 +7092 6 42.0068 3.03472 36.7639 -8.02624 -14.3838 3.82934 +7093 4 41.5138 2.21919 36.6422 -1.8797 -9.24856 -19.1073 +7094 4 41.9017 3.12445 37.6992 6.42334 14.3979 20.8626 +7095 6 39.3283 22.4329 33.1866 16.7976 22.9312 16.1168 +7096 4 39.617 22.6043 34.1233 -9.1007 -15.4059 -24.4851 +7097 4 39.2996 23.351 32.8579 -1.9326 -13.3537 -7.72798 +7098 6 18.5014 34.9723 11.9503 -40.872 8.93582 -22.0032 +7099 4 19.313 34.895 12.3871 37.9781 -3.12322 33.9295 +7100 4 17.8134 35.1232 12.6133 -0.0311416 1.40314 8.7121 +7101 6 22.862 14.1089 0.203393 17.2545 -2.37957 19.5806 +7102 4 23.1276 14.8054 41.5255 0.219481 9.03583 -13.3452 +7103 4 23.4003 14.3117 0.999915 -8.23864 -6.67581 -7.59618 +7104 6 30.9898 16.6325 33.7811 -26.24 4.82889 -18.7278 +7105 4 30.4991 16.9295 32.9906 -1.06726 -7.21679 15.5744 +7106 4 31.8724 16.8786 33.545 20.2345 1.84197 6.64809 +7107 6 28.4142 35.5086 5.55132 5.25795 11.5001 -0.86936 +7108 4 29.133 34.8901 5.6729 7.87573 -11.0207 0.32142 +7109 4 28.8444 36.3678 5.44284 -5.96253 -1.38672 0.306744 +7110 6 2.06178 31.4487 10.6522 7.7724 2.5252 5.43788 +7111 4 2.46787 32.1741 10.1582 1.48866 -1.05725 0.00513454 +7112 4 1.12423 31.5492 10.4902 -10.7705 -1.69396 -4.48797 +7113 6 5.96168 9.75465 21.3469 -3.89643 8.81348 -50.5901 +7114 4 6.28958 10.5041 20.7544 -9.04712 -29.7196 22.9081 +7115 4 5.37557 9.21645 20.7377 15.5825 17.9805 22.1648 +7116 6 24.7784 26.6095 2.66066 11.1746 -2.24162 5.28408 +7117 4 23.9956 26.7754 2.10108 -2.29597 -10.0774 9.56872 +7118 4 24.6953 25.8682 3.30791 -10.2989 11.7132 -14.8816 +7119 6 45.7373 4.24983 18.6143 27.3178 -0.763462 -4.2154 +7120 4 46.5067 4.85242 18.4954 -19.0177 -2.03966 3.70694 +7121 4 46.1538 3.38182 18.4484 -14.6954 3.88493 3.6473 +7122 6 4.46307 0.776675 15.9004 -0.0751459 19.7124 -7.24544 +7123 4 4.28648 41.7452 15.8506 7.90268 -11.6504 4.49907 +7124 4 5.34722 0.941656 16.2766 -7.84 -9.44871 -1.18019 +7125 6 2.43543 19.4835 25.3975 -8.02289 7.34849 22.5637 +7126 4 1.8039 19.0427 26.0095 9.34608 -2.48106 -16.7091 +7127 4 2.63666 18.9452 24.6346 -2.8512 -10.1259 -3.82486 +7128 6 40.5893 8.48301 5.11314 -1.35782 -12.8068 -2.32465 +7129 4 40.7524 9.27543 5.61119 -3.30667 17.7402 10.4879 +7130 4 41.4486 8.05286 5.16027 3.34022 -8.8045 -8.92488 +7131 6 49.3107 22.3512 41.5276 -10.6582 56.3201 6.76971 +7132 4 48.577 22.7852 41.0387 15.264 -8.60422 5.01334 +7133 4 49.2575 21.458 41.2835 -0.448838 -46.7272 -11.6484 +7134 6 0.358901 40.9209 20.5803 -19.8443 -5.20423 -21.0143 +7135 4 0.209912 39.9476 20.5616 0.00996972 10.506 -0.843682 +7136 4 54.6254 41.351 20.0384 15.1519 -13.0167 14.2251 +7137 6 34.868 15.3449 38.0159 -4.77394 11.9701 -21.6163 +7138 4 34.21 16.0699 37.905 14.1938 -11.5268 -7.28032 +7139 4 35.478 15.4115 37.2329 -18.0572 6.07255 16.3223 +7140 6 7.76403 26.0071 29.8556 5.34791 -0.957035 4.21351 +7141 4 8.62364 26.4528 30.0224 -8.82329 -12.5157 -0.945539 +7142 4 7.90301 25.0604 30.0866 1.23738 19.4493 -2.25897 +7143 6 40.714 22.798 20.4449 30.2403 28.6605 -20.1452 +7144 4 41.3584 23.4838 20.081 -22.4198 -29.1089 11.875 +7145 4 40.2102 23.3285 21.0558 -12.075 4.18803 12.4472 +7146 6 37.6868 25.6422 36.0641 6.66209 -5.59755 13.6904 +7147 4 38.2808 24.8923 36.0269 4.65063 -3.44496 7.57849 +7148 4 37.3429 25.6351 35.1859 -16.0941 8.70932 -25.1352 +7149 6 5.45062 23.9828 10.2587 5.16865 5.9624 5.01697 +7150 4 5.97911 23.8188 9.45867 -6.21725 4.51436 8.29683 +7151 4 5.82702 24.8173 10.6422 -10.2102 -24.7042 -13.9856 +7152 6 48.3972 21.0585 38.1887 36.079 14.8531 -15.9941 +7153 4 48.9083 20.6932 38.9203 -9.15007 -3.24726 4.47194 +7154 4 49.1186 21.3212 37.5505 -33.8036 -6.43701 14.9947 +7155 6 15.2894 25.0118 3.53737 -15.5341 -16.8072 10.9824 +7156 4 15.3523 24.0463 3.54635 7.80908 -0.218079 -10.1213 +7157 4 14.6524 25.152 4.25109 -0.971191 12.1275 -1.41446 +7158 6 46.3973 40.2818 20.0864 -5.10979 -28.8528 0.810189 +7159 4 46.7099 39.3289 20.1836 -4.69047 35.7762 -3.66479 +7160 4 47.1343 40.8792 20.2285 11.4236 3.93541 -0.385178 +7161 6 34.6613 36.4755 0.335066 -24.7851 30.4749 -21.6933 +7162 4 34.8743 36.0541 1.15687 -4.43901 -4.57192 24.0914 +7163 4 33.7851 36.9546 0.454416 30.1492 -20.7825 2.99091 +7164 6 52.5881 7.99834 30.4195 9.51271 -12.4348 0.483116 +7165 4 52.1042 8.76616 30.7719 -8.49213 -7.21741 -10.9068 +7166 4 52.0722 7.46347 29.7764 0.520668 12.6171 10.1624 +7167 6 32.0714 3.86484 29.4697 -9.7538 -17.9077 -31.6249 +7168 4 31.6702 2.97314 29.6052 7.93851 20.6113 2.31556 +7169 4 32.0839 3.94733 28.4741 0.539668 -3.17995 32.4864 +7170 6 20.3786 17.8365 28.6466 -12.59 16.0252 -12.2548 +7171 4 19.5397 17.5939 29.0718 10.0495 1.57584 1.91854 +7172 4 20.0545 18.3008 27.843 10.529 -6.18443 10.1885 +7173 6 30.4085 41.1704 41.0135 6.18506 -3.22706 -14.2809 +7174 4 30.53 40.7341 40.1581 -10.3332 2.11637 -0.589059 +7175 4 31.2241 40.9477 41.4498 10.7912 2.88832 12.9661 +7176 6 35.4567 32.8541 27.9296 20.1033 20.3116 -25.2142 +7177 4 35.1103 33.2872 28.7174 -1.27312 4.66796 4.01126 +7178 4 35.9087 33.5476 27.342 -15.0191 -24.2746 21.4934 +7179 6 14.3794 6.67806 12.7301 -1.9413 28.2373 -4.00169 +7180 4 15.2373 6.26429 12.8613 2.01848 -2.11516 -0.858514 +7181 4 14.5332 7.65903 12.7289 -3.54891 -27.4927 -2.87641 +7182 6 41.884 41.5441 20.3292 17.5267 3.97767 -7.39307 +7183 4 42.6467 41.3531 19.7473 -6.80228 5.43899 6.41045 +7184 4 41.2989 40.8038 20.1922 -8.54368 -4.96293 -3.75352 +7185 6 46.4016 22.5784 8.86191 7.75251 -10.6521 7.11129 +7186 4 45.8476 21.8716 8.52158 -12.3576 2.35246 -8.51817 +7187 4 47.0146 22.0703 9.39636 1.75986 6.35736 5.22437 +7188 6 17.4049 20.6472 13.8946 9.03444 14.2526 1.49725 +7189 4 17.6929 21.5842 14.0543 -8.3446 -25.4959 -7.46489 +7190 4 17.3265 20.4984 12.9333 2.034 6.01629 5.63707 +7191 6 8.18883 9.49722 13.352 -36.2403 7.79383 -0.838203 +7192 4 7.38606 10.0563 13.5919 32.9103 -12.129 -3.09847 +7193 4 9.02271 9.90793 13.6245 -5.40631 9.4956 5.41337 +7194 6 7.5857 14.8045 29.5864 0.660595 8.18183 -2.22865 +7195 4 7.08502 14.4366 30.3218 -1.52277 2.83209 3.37304 +7196 4 7.02502 15.474 29.1565 2.15616 -5.78955 1.98978 +7197 6 29.5787 39.2199 22.642 -23.9064 2.77655 4.40715 +7198 4 29.7923 38.7231 23.4359 12.3113 -5.95711 5.92816 +7199 4 30.3289 39.2945 22.0576 16.6647 -3.01011 -3.30282 +7200 6 19.7261 28.8048 8.43629 7.07867 10.1416 -1.30332 +7201 4 19.5094 27.8711 8.56662 5.24428 2.50367 -2.7317 +7202 4 20.6808 28.8901 8.64157 -12.3267 -4.04756 -0.658665 +7203 6 20.0918 21.6433 25.9098 -22.8378 18.9737 -2.62589 +7204 4 20.6828 21.9331 26.6394 -14.5657 0.991195 -11.6344 +7205 4 19.2872 22.2354 25.9429 24.6623 -16.2361 5.64257 +7206 6 12.7798 16.1171 22.7918 2.83481 -1.66518 -8.4999 +7207 4 12.1052 16.761 22.5802 -5.26913 11.1277 0.000470885 +7208 4 12.4145 15.3113 22.3987 5.67676 1.62415 3.74644 +7209 6 7.09341 27.2127 17.9852 -17.6727 17.6357 -2.43489 +7210 4 7.71878 26.5086 17.8851 15.5779 -18.3258 -2.50971 +7211 4 7.24623 27.7931 17.2297 2.82114 0.873921 -0.89624 +7212 6 32.4121 8.69011 34.8574 -11.3856 31.068 25.9423 +7213 4 32.686 9.10208 35.716 -2.62469 -14.8204 -24.695 +7214 4 31.4981 9.04705 34.7249 20.8054 -13.4625 -4.53694 +7215 6 50.3489 28.2274 17.5408 2.96892 -19.9668 3.87059 +7216 4 50.2931 27.3328 17.9381 -3.71715 13.2344 -0.552608 +7217 4 51.012 28.0828 16.8476 -2.81747 8.99858 -3.49204 +7218 6 15.6752 32.1523 25.7996 -24.1097 -1.02752 -8.0065 +7219 4 16.4469 32.5721 26.1513 19.1192 7.47953 7.03048 +7220 4 15.1241 32.8942 25.4834 5.39501 -5.59697 3.80799 +7221 6 41.2942 22.0009 29.6469 23.8016 -11.3242 12.4312 +7222 4 40.6197 22.5451 29.2897 -20.6362 19.5621 -14.8771 +7223 4 40.8321 21.2604 30.0334 -1.27155 -6.80964 4.85239 +7224 6 24.5512 12.7478 8.87624 0.539479 -2.56763 -16.1827 +7225 4 24.2317 13.5544 9.29419 1.48927 0.294937 0.678301 +7226 4 24.2485 12.8104 7.9491 4.47413 -5.17195 11.4459 +7227 6 47.3043 20.1171 10.4067 20.0451 13.2477 8.4905 +7228 4 48.2327 20.3756 10.3708 -0.951507 4.56311 9.88278 +7229 4 47.2371 19.5522 9.64912 -14.6685 -17.4861 -17.2657 +7230 6 17.6686 14.2187 29.9453 7.31834 -6.07886 -8.28437 +7231 4 16.8567 14.6777 30.1627 -12.3548 11.6861 -0.426412 +7232 4 18.1621 14.7508 29.3045 -6.68566 0.573373 4.02912 +7233 6 21.3468 34.5864 28.5404 1.3464 21.7174 -7.002 +7234 4 21.5866 35.4807 28.2285 -6.04705 -7.23946 1.73439 +7235 4 21.8012 34.5133 29.372 6.90897 -8.71765 12.9147 +7236 6 35.0919 4.05058 4.01374 -15.5825 9.30565 11.5721 +7237 4 34.2387 3.74233 4.43927 22.4566 16.9059 -11.4445 +7238 4 35.1406 5.04582 3.93988 -11.3656 -25.7387 7.52347 +7239 6 29.9083 8.58745 22.5962 -15.8002 1.46007 -28.7439 +7240 4 29.4293 8.33193 21.7391 23.5037 3.33824 36.5279 +7241 4 30.4512 7.83881 22.8901 -6.5033 3.48596 -7.29863 +7242 6 9.80484 32.9578 15.933 -3.40746 -8.77641 -12.0557 +7243 4 9.78146 31.9986 16.1651 13.0086 23.7442 4.23133 +7244 4 10.4547 33.4728 16.4465 2.19651 -19.1398 5.78046 +7245 6 24.9207 14.2283 32.5839 15.8568 -2.03515 22.8032 +7246 4 25.4679 14.491 33.3602 -10.7028 -6.65113 -14.6818 +7247 4 24.5651 15.0495 32.2637 -5.99659 7.67207 -7.30645 +7248 6 49.6599 21.9679 26.2292 42.3899 27.0609 3.31449 +7249 4 50.4576 21.5325 26.6526 -24.3124 13.7703 -9.69582 +7250 4 49.9726 22.89 25.9802 -16.6307 -33.6109 8.97028 +7251 6 39.2146 29.6271 28.776 1.2649 -6.72815 -4.66326 +7252 4 39.3113 29.0399 29.5368 -1.10705 1.67847 4.24024 +7253 4 39.5646 29.0864 28.052 -0.275695 2.9096 0.748968 +7254 6 50.692 34.7829 39.7485 29.9384 -8.83369 -9.14761 +7255 4 51.6379 34.6172 39.5245 -10.9597 10.0847 13.0799 +7256 4 50.284 34.1892 39.1195 -14.598 -6.88033 -5.74908 +7257 6 29.205 20.8761 19.5187 12.6622 -8.88768 18.517 +7258 4 30.1458 21.1462 19.5468 -10.0278 2.51211 -7.13483 +7259 4 28.7621 21.2804 18.7794 -5.02457 12.868 -15.5739 +7260 6 45.8413 1.41619 21.3894 -25.1775 13.0352 -19.0829 +7261 4 45.002 1.0285 21.6935 10.996 -3.183 3.42833 +7262 4 46.5512 0.981978 21.8333 16.3199 -17.0363 14.4799 +7263 6 26.0942 5.84138 12.9755 -8.81801 -1.79204 -2.94978 +7264 4 26.5644 5.00851 12.8396 1.48472 -6.22175 2.21387 +7265 4 25.1658 5.65249 12.7519 4.56693 -2.33816 -1.27821 +7266 6 9.00853 19.0479 23.7214 20.279 18.3012 -13.9253 +7267 4 8.07192 18.8993 23.8406 -12.3386 2.44029 -0.494901 +7268 4 9.09287 19.8709 23.17 -6.05991 -16.4473 11.9144 +7269 6 47.699 14.1778 40.0244 8.37408 5.46764 -8.11648 +7270 4 48.526 14.369 39.5365 -13.6583 -0.0280305 9.55934 +7271 4 47.2742 15.0291 40.2237 1.48315 -6.20176 -4.56159 +7272 6 47.9891 19.7944 0.501942 -52.5058 -34.5194 5.9677 +7273 4 48.5389 19.8149 1.25758 31.4646 9.24384 22.8657 +7274 4 47.3233 19.1101 0.79406 16.1078 24.936 -21.6052 +7275 6 27.1644 39.5895 31.4222 -35.4984 -42.2857 -13.2745 +7276 4 26.8828 40.2644 32.0188 2.45392 19.408 13.0965 +7277 4 26.334 39.0158 31.3353 32.2444 14.87 -2.1562 +7278 6 20.718 15.281 27.2921 -20.5288 29.0824 -25.1338 +7279 4 19.7916 15.5288 27.1303 0.0426049 -12.6319 11.5337 +7280 4 21.1251 16.0883 26.9354 13.4588 -8.377 2.43969 +7281 6 53.2931 3.12982 19.6939 21.059 35.3193 6.93312 +7282 4 52.5111 3.68486 19.642 -0.600406 9.66435 -1.15328 +7283 4 52.9649 2.26115 19.6482 -6.97037 -43.0252 -2.92507 +7284 6 40.7577 33.3874 24.037 12.7176 -1.25655 15.6318 +7285 4 41.575 33.1492 24.5319 -10.6485 3.51614 -11.0419 +7286 4 40.1417 32.64 24.1417 6.01104 2.31945 0.566227 +7287 6 50.2034 37.8915 21.3784 34.5696 42.4783 -9.46203 +7288 4 50.977 37.3667 21.5595 20.6596 -6.9612 4.63629 +7289 4 49.5128 37.3071 21.51 -51.1752 -39.6198 7.18684 +7290 6 41.3315 2.34663 21.9881 -5.34027 -0.787955 22.4754 +7291 4 41.3778 2.5308 21.0564 -4.51788 5.59338 -11.8441 +7292 4 40.4369 2.61524 22.307 16.348 -5.18373 -12.1741 +7293 6 3.68887 21.2797 14.3363 -13.7249 24.7693 -29.296 +7294 4 4.1389 21.9084 14.895 6.09004 12.6164 9.74183 +7295 4 3.85532 20.4521 14.7268 10.1618 -35.5887 19.7816 +7296 6 34.2749 11.1621 36.6211 6.86722 -26.3475 -8.98455 +7297 4 34.1457 10.3739 37.2084 1.76529 18.7936 -6.49638 +7298 4 34.0208 11.9523 37.0887 -10.0392 4.20616 19.2695 +7299 6 24.047 21.9251 23.4534 9.96695 -9.01801 9.45846 +7300 4 24.1056 21.4984 22.592 0.489969 -1.19981 -5.95122 +7301 4 24.6049 21.3417 24.0221 -10.3198 12.7259 -7.25629 +7302 6 18.8859 0.355593 4.41703 6.91373 -0.488994 13.8226 +7303 4 18.8848 41.346 4.15992 -3.4937 -3.21088 -8.69706 +7304 4 19.4141 0.350836 5.23016 -4.89519 7.76131 -7.17368 +7305 6 1.61894 7.82812 17.7388 11.0013 -2.20401 0.0755565 +7306 4 1.69825 6.91132 17.4299 0.598176 5.44338 0.144381 +7307 4 0.751076 7.92867 18.1276 -6.88769 -1.80246 0.772288 +7308 6 9.88357 31.5477 26.4865 20.7425 -47.9078 -25.9665 +7309 4 9.77347 30.8406 25.7562 4.13802 32.2768 29.9214 +7310 4 9.16637 32.1481 26.416 -28.5637 22.827 -5.6847 +7311 6 46.9801 33.0031 20.3665 8.92807 -2.6835 25.0439 +7312 4 47.1906 32.5959 21.2783 -12.5238 7.50902 -41.0074 +7313 4 46.473 32.3868 19.8049 3.08737 -2.68707 12.6131 +7314 6 49.5381 29.29 21.3848 5.35466 4.48298 6.61079 +7315 4 50.3596 28.8237 21.4263 11.6576 -22.6485 -14.6982 +7316 4 49.6544 29.7814 22.1942 -19.8316 15.0268 8.13943 +7317 6 13.5135 31.8933 19.1567 20.4477 19.0535 18.7588 +7318 4 12.9544 32.0303 19.9484 11.7182 -3.51681 -10.2564 +7319 4 14.3688 32.3555 19.4049 -26.6747 -15.4769 -10.5401 +7320 6 46.6242 34.0973 16.9259 3.25439 -22.1556 18.333 +7321 4 46.8986 34.1178 16.0034 3.18051 -0.659651 -5.23437 +7322 4 46.9878 33.2447 17.2966 -6.98741 23.2488 -14.973 +7323 6 19.7685 39.5238 2.42723 -1.93992 9.56528 -9.07466 +7324 4 20.504 40.1421 2.55739 -2.20075 -2.41675 -0.557551 +7325 4 19.2228 39.9982 1.75695 7.86662 -14.3322 13.7479 +7326 6 16.5372 9.39399 28.3106 5.81076 4.55242 0.698497 +7327 4 16.5228 10.3583 28.3138 -6.10914 3.2393 2.1867 +7328 4 17.4567 9.2086 28.1181 8.68803 -11.6531 -1.09187 +7329 6 3.04764 33.3834 8.9498 9.15555 8.47462 14.2626 +7330 4 2.34782 34.0603 8.86882 1.18173 -6.7492 -12.1187 +7331 4 3.16543 32.8691 8.13996 -9.91006 6.39371 -6.60301 +7332 6 49.6799 28.314 0.198287 -24.1009 9.02482 3.02524 +7333 4 50.5864 28.3416 41.8577 25.8797 -1.22492 -6.2647 +7334 4 49.539 27.5375 0.746128 -0.431885 -1.84115 5.43874 +7335 6 1.41501 6.84656 30.491 -4.80497 13.9866 22.936 +7336 4 1.80101 7.66454 30.873 3.64878 -10.2221 -13.1962 +7337 4 0.770406 6.61566 31.1883 9.6026 -0.286793 -13.8716 +7338 6 19.7721 9.41455 33.714 -8.86768 10.4812 -29.5452 +7339 4 19.9336 8.45599 33.7164 -2.74186 3.51224 -8.50186 +7340 4 19.4649 9.70036 32.7878 8.54711 -12.9815 34.2723 +7341 6 26.1689 11.9219 3.60877 17.3014 14.1658 -18.8808 +7342 4 25.6285 12.278 4.29668 -11.0155 5.7348 17.6305 +7343 4 26.0891 10.974 3.64129 -4.70103 -13.8965 4.54114 +7344 6 33.2526 2.15457 18.2061 -11.4346 36.8522 -3.73875 +7345 4 32.7853 2.99777 18.4754 10.6797 -23.9754 -11.6278 +7346 4 32.6748 1.45157 18.4903 -6.58847 -5.37306 4.71859 +7347 6 1.56641 29.1164 15.6218 -13.5802 38.9916 52.9136 +7348 4 0.75332 28.6899 15.9164 -2.28927 1.65734 -1.12046 +7349 4 1.88381 28.6368 14.9104 18.6776 -39.2188 -53.7174 +7350 6 41.7212 4.09992 39.5909 -11.2791 25.9615 -27.213 +7351 4 41.4168 4.81457 38.9155 6.653 -41.6332 33.8875 +7352 4 40.9635 3.53859 39.8438 1.60091 7.46224 -7.31473 +7353 6 28.6931 41.7984 21.1891 -6.68751 -8.42641 -4.80462 +7354 4 29.0735 0.780303 21.3271 9.25035 -16.558 -3.13259 +7355 4 29.3834 41.1221 21.0106 -2.7364 22.7931 4.70591 +7356 6 11.6395 12.4176 35.4525 -19.931 13.6599 -6.89173 +7357 4 11.6974 12.2316 36.3791 0.0383878 -4.43782 22.0781 +7358 4 12.5438 12.3774 35.1867 22.2579 1.64914 -11.6458 +7359 6 9.79005 12.0613 0.287125 39.0331 19.741 15.6941 +7360 4 10.6741 12.3652 0.649112 -24.288 -6.9143 -28.8601 +7361 4 9.37178 11.7496 1.07064 -16.9981 -12.0004 12.0483 +7362 6 48.1738 12.4001 9.21087 -14.7098 16.6281 -3.51107 +7363 4 48.3046 11.757 8.50338 5.36034 -5.93883 0.971929 +7364 4 48.886 12.3441 9.8545 11.7295 -7.72549 2.46367 +7365 6 20.1355 24.3829 18.9522 12.9308 -0.734849 -39.1055 +7366 4 19.4937 23.7815 18.5135 12.9255 8.80461 9.87411 +7367 4 20.8069 24.6162 18.234 -21.1698 -7.06963 26.7537 +7368 6 16.5393 31.2961 16.4761 -1.92172 -19.5246 -12.7122 +7369 4 16.66 32.2288 16.679 -4.64409 4.5232 17.4599 +7370 4 16.1207 30.7474 17.1716 1.36469 17.4989 2.94612 +7371 6 1.78169 14.6393 36.2977 19.9207 14.6923 -9.09136 +7372 4 1.03986 14.2937 35.8105 -15.9251 -7.35249 0.645581 +7373 4 1.68132 14.4688 37.2355 -8.64532 -4.94464 12.0587 +7374 6 4.36624 29.2084 29.5903 15.7403 17.1522 -11.4447 +7375 4 4.94475 28.7816 30.2313 0.42296 -3.8665 4.22363 +7376 4 4.9316 29.8996 29.1557 -19.5902 -17.4666 6.54186 +7377 6 43.6839 0.248111 22.6506 -19.7732 -13.3298 -9.50689 +7378 4 42.8764 0.661685 22.3065 0.028666 2.48852 1.60322 +7379 4 43.5183 41.2016 22.5042 11.2477 10.9397 1.57875 +7380 6 52.4994 40.9828 27.2386 -0.538127 -6.12089 -28.931 +7381 4 52.76 40.8447 26.286 -9.02638 3.90908 21.7421 +7382 4 53.2684 41.4137 27.6303 2.05735 4.02476 1.85103 +7383 6 25.5814 23.8969 27.7396 -24.7861 2.98762 0.531627 +7384 4 24.718 24.3642 27.6072 20.4038 -13.4527 4.15226 +7385 4 26.2821 24.4835 27.457 3.8963 1.45656 -1.88052 +7386 6 23.1228 17.031 33.3243 -5.52517 1.23961 5.4323 +7387 4 23.1399 17.5083 34.1558 0.441881 0.23205 -0.480567 +7388 4 22.8557 16.1383 33.5546 -4.67547 -8.64305 1.56256 +7389 6 2.92722 11.8725 21.3561 -41.4423 -19.1296 -19.7046 +7390 4 2.18606 11.2638 21.6443 29.5918 21.1066 -8.34803 +7391 4 3.54191 11.9259 22.0595 17.1072 -0.484489 21.5157 +7392 6 2.18317 4.15265 30.0257 5.779 -9.3787 -10.7468 +7393 4 2.12921 5.11001 30.0802 -2.76576 12.2821 -0.843831 +7394 4 2.67493 3.96573 29.2018 -3.29095 2.88479 4.98522 +7395 6 26.6728 30.2949 13.4768 7.17255 0.654769 14.1147 +7396 4 25.7117 30.2905 13.6467 8.22624 -2.44269 3.31295 +7397 4 27.1112 30.3188 14.3546 -11.9073 -0.623098 -17.8849 +7398 6 24.8734 30.8117 10.8292 -29.6944 -3.60301 -2.53615 +7399 4 25.2254 30.0431 10.3884 7.40196 -6.71761 -6.36825 +7400 4 25.5983 31.2424 11.2381 22.0508 11.6497 12.6203 +7401 6 53.1723 24.107 4.51212 -8.50651 -29.3458 16.902 +7402 4 53.5087 24.8189 4.00388 11.9327 21.9784 -14.7749 +7403 4 53.9335 23.6869 4.92936 2.49868 2.30602 2.88115 +7404 6 24.9006 4.49574 23.9943 -15.2803 12.8054 -1.91421 +7405 4 24.3197 5.26112 23.9044 -17.3839 -11.7779 6.16284 +7406 4 25.6928 4.95696 23.7819 42.3091 -2.82475 -3.31223 +7407 6 34.6808 1.64534 41.2582 -1.16689 -16.4189 -19.1193 +7408 4 35.6107 1.42238 41.0689 -7.35569 3.11738 8.02352 +7409 4 34.6894 2.06091 0.199506 5.11707 10.3461 19.9542 +7410 6 13.3318 19.5273 16.3875 10.456 -31.2285 9.008 +7411 4 13.8245 19.0713 15.6714 -4.89067 6.02882 4.66139 +7412 4 13.1633 18.7854 17.0362 1.8233 23.0525 -16.1268 +7413 6 48.6827 0.169575 20.4108 24.7259 -31.926 -14.6767 +7414 4 49.2893 41.6148 19.7702 -18.6338 21.3246 17.3218 +7415 4 48.933 41.6689 21.2514 -6.5025 5.85221 0.333279 +7416 6 43.0578 27.7881 11.5189 -10.6888 1.76469 -10.0665 +7417 4 42.6538 28.0077 10.6554 5.1393 -6.0393 10.108 +7418 4 43.5199 28.5835 11.7935 3.33621 0.984046 2.36511 +7419 6 25.7084 21.3766 35.1933 7.92601 18.71 -2.37973 +7420 4 25.8037 22.0957 34.5091 -5.30878 -22.9017 16.0752 +7421 4 25.4462 20.5484 34.7558 3.58761 11.0813 -0.636196 +7422 6 44.7325 4.60288 27.7529 -5.18995 0.47983 -9.95788 +7423 4 44.2388 4.02478 27.1463 1.34738 -4.40857 1.63455 +7424 4 44.3371 5.47709 27.6067 3.7052 -1.13476 4.16529 +7425 6 41.2786 11.441 34.2043 -0.416747 21.9122 -5.07112 +7426 4 40.7165 11.5703 33.4237 0.0697438 -4.14349 0.395824 +7427 4 41.2047 10.5155 34.4107 -4.51201 -19.8544 2.93408 +7428 6 19.8751 36.6454 2.03332 12.5662 31.6724 6.60432 +7429 4 20.6794 36.321 2.43856 -1.22315 -24.7147 -1.51883 +7430 4 20.0441 37.6041 2.15193 -20.0718 -8.75186 -9.57731 +7431 6 27.484 4.65653 6.35518 1.28922 -40.4385 -58.6648 +7432 4 27.5497 3.77116 6.72735 -1.75384 3.56143 11.9553 +7433 4 27.4257 5.33486 6.97498 -2.79123 31.4549 44.9969 +7434 6 16.8428 30.7659 39.9509 7.31092 -42.6244 -5.47757 +7435 4 16.9464 31.3097 40.7337 2.60533 1.47109 13.0941 +7436 4 17.1496 29.8303 40.1512 -5.48449 28.5555 1.20442 +7437 6 51.1542 15.2049 16.3406 35.1838 19.4064 -24.6303 +7438 4 51.2473 16.0791 15.87 -9.06363 -20.4986 13.944 +7439 4 52.0128 14.747 16.0894 -33.4595 8.32861 13.6861 +7440 6 49.9911 21.2271 35.9695 16.4294 -24.4585 13.2328 +7441 4 49.3547 21.5056 35.3276 -17.8928 6.13619 -17.6667 +7442 4 49.9245 20.2453 36.0087 2.29216 20.3869 -1.95357 +7443 6 34.4275 0.15221 5.68266 -0.837995 23.3079 0.855413 +7444 4 34.2957 0.929489 6.27037 2.93096 -11.6463 -16.4536 +7445 4 34.3488 0.459476 4.74482 0.623699 -7.30698 18.2278 +7446 6 48.316 11.5365 19.8846 -3.65813 -3.14803 11.8504 +7447 4 47.8503 11.3247 20.7373 6.31016 14.4835 -28.1035 +7448 4 47.7834 12.1052 19.2757 1.33379 -13.4076 20.6299 +7449 6 4.19577 39.4409 13.3607 25.3524 9.34899 10.5928 +7450 4 4.92582 39.74 13.9847 -33.0668 -7.48624 -17.3574 +7451 4 3.31127 39.5736 13.758 11.9971 1.78205 4.76714 +7452 6 8.7457 16.1809 8.53298 -1.62633 17.1572 -22.0575 +7453 4 8.74512 16.8853 9.19115 0.0519099 -7.3494 1.25428 +7454 4 8.72812 16.6658 7.66651 -0.023414 -16.7756 16.7144 +7455 6 29.0271 14.2712 26.5342 -13.8591 45.9397 20.1216 +7456 4 29.0757 15.2697 26.7309 6.93185 -43.1811 -12.6551 +7457 4 28.1042 14.0702 26.7795 9.9397 -3.04712 -3.53591 +7458 6 27.3813 14.5204 8.1419 -14.0666 1.8718 0.247246 +7459 4 26.4091 14.3966 8.10069 17.9482 5.30051 2.04476 +7460 4 27.5539 15.4689 8.31094 -4.76419 -14.5771 -1.3831 +7461 6 14.1301 27.2156 32.9232 24.3629 15.6041 -10.7258 +7462 4 14.926 27.3266 33.4685 -8.09546 -2.45296 -2.52419 +7463 4 13.4702 26.8045 33.4616 -14.5983 -10.6772 12.2116 +7464 6 31.6563 35.7792 21.2709 -29.1401 -25.1051 5.88501 +7465 4 32.0219 36.5153 21.7512 6.27263 14.1007 6.62418 +7466 4 30.8825 35.462 21.8184 22.9209 7.6802 -13.887 +7467 6 54.2186 28.7134 16.8958 -10.3287 11.0002 2.01575 +7468 4 53.5002 28.4234 16.309 3.24852 -2.61584 3.16662 +7469 4 53.9524 29.6107 17.1726 0.515277 -7.78004 -0.375364 +7470 6 9.0512 5.27483 17.1492 25.6572 1.38615 -17.9054 +7471 4 9.89534 5.12229 16.6101 -31.8522 3.085 22.1798 +7472 4 8.85255 6.23494 17.0921 1.81156 -15.0607 2.57474 +7473 6 29.6868 9.77258 26.5671 22.9889 -14.8503 10.4327 +7474 4 30.5444 9.2887 26.5838 -17.3341 11.3615 1.53321 +7475 4 29.3655 9.78642 27.4819 2.88877 -1.07091 -0.346791 +7476 6 44.0288 31.1766 32.1743 -14.2068 1.02328 22.4178 +7477 4 43.2475 30.9789 32.739 9.50682 -2.17476 -16.522 +7478 4 44.5788 31.7142 32.7564 8.88854 3.82935 -1.95952 +7479 6 53.49 3.62433 25.1454 11.2777 4.02107 -26.8953 +7480 4 54.1404 4.33507 25.1993 -2.49783 6.11479 15.045 +7481 4 53.6886 3.29227 24.2489 -10.294 -6.80459 12.4065 +7482 6 12.451 22.8746 3.38821 10.4278 8.96452 22.9237 +7483 4 12.7779 22.025 3.15024 17.1772 -24.972 1.67394 +7484 4 11.7815 22.9738 2.74712 -31.3784 16.165 -21.5343 +7485 6 39.42 29.6871 0.722943 17.2287 20.3893 -0.939439 +7486 4 39.938 29.1007 0.168548 -5.00448 -5.71086 -1.61555 +7487 4 38.6697 29.2119 1.03517 -14.5725 -11.7208 3.22357 +7488 6 13.7451 37.8179 23.0399 -3.65878 -32.3471 -6.65898 +7489 4 14.6418 38.0465 23.3627 -20.7195 15.519 -6.09735 +7490 4 13.1315 38.5597 22.9108 15.1185 11.2609 5.5967 +7491 6 33.3417 41.2334 -0.000336223 20.2285 27.8942 26.4667 +7492 4 33.8463 0.176253 41.7571 -17.5829 -26.3423 -4.93882 +7493 4 33.4991 41.0748 0.960438 -12.6248 -4.93214 -20.7453 +7494 6 15.7246 3.51737 6.33987 10.6879 -4.05507 31.4744 +7495 4 14.9251 3.29652 6.83809 -1.96505 1.65417 1.3128 +7496 4 15.4345 3.71468 5.4634 -8.944 6.24557 -22.4591 +7497 6 27.7713 30.7539 5.06912 -9.69485 -19.9648 -11.4393 +7498 4 28.5319 30.6575 5.66481 -7.77203 -4.90526 -3.90413 +7499 4 27.6074 29.8515 4.67882 9.36195 16.9347 11.4385 +7500 6 13.3277 7.57287 23.3467 18.1651 -5.37845 17.9429 +7501 4 14.1986 7.86136 23.0073 -11.0143 -2.49266 1.50668 +7502 4 12.7134 7.55433 22.6278 -8.93981 2.52131 -14.7715 +7503 6 38.3049 37.3174 27.9983 8.70135 -12.5747 15.655 +7504 4 38.3154 37.3922 27.0572 -6.74668 8.75695 -30.2201 +7505 4 39.0324 36.7087 28.1704 1.61648 -2.88985 11.5174 +7506 6 35.8266 12.5392 12.0897 -2.57405 -7.53067 12.8361 +7507 4 35.6491 11.5922 12.0112 2.97069 1.46586 -4.70523 +7508 4 36.2655 12.8127 11.2954 6.10525 2.83369 -11.8718 +7509 6 52.1153 23.0889 41.2774 53.3714 4.98692 -14.9993 +7510 4 52.5505 23.0114 40.3503 -31.9828 -2.74691 35.5054 +7511 4 51.1752 22.9201 41.2974 -16.3051 -5.99839 -13.4785 +7512 6 39.5458 11.6586 16.6081 -4.87816 2.10267 -34.9091 +7513 4 39.8889 10.7596 16.6462 4.61035 -3.54577 11.4771 +7514 4 39.4661 12.017 17.4857 2.58954 -3.33375 20.5696 +7515 6 0.680688 9.01153 7.97148 24.3969 36.1639 -33.0882 +7516 4 54.7452 9.01592 8.14854 -24.8099 -10.5681 8.91807 +7517 4 1.15172 8.32837 8.40327 2.66278 -26.2854 21.5078 +7518 6 42.3319 28.747 39.482 14.4944 54.9029 13.7373 +7519 4 41.6099 28.5069 40.0315 -24.977 -16.9351 14.372 +7520 4 42.5658 28.0062 38.9777 10.1954 -37.5926 -27.6332 +7521 6 38.7351 30.2774 16.2793 4.0737 2.19128 11.2593 +7522 4 38.8758 29.8829 17.1681 -0.562728 7.98522 -10.8415 +7523 4 39.3736 31.0181 16.2214 -9.64538 -12.7452 3.65311 +7524 6 7.59373 18.0328 0.655349 -39.2466 -13.429 1.02247 +7525 4 7.12412 17.545 1.38102 15.2508 10.2608 -15.5396 +7526 4 8.49503 18.0746 0.920891 28.7098 -1.69475 13.4339 +7527 6 33.7283 34.5883 24.1367 2.81913 -0.677006 -1.55035 +7528 4 33.5209 35.3543 23.5868 -0.36085 -2.23271 3.31185 +7529 4 34.0202 34.925 24.9956 3.1898 -0.550642 -1.12415 +7530 6 16.0108 40.0553 39.5926 -11.937 1.54577 -14.812 +7531 4 16.9471 40.1686 39.433 15.7688 -0.191962 4.71606 +7532 4 15.632 40.0274 38.6953 -1.55756 -1.47356 6.94311 +7533 6 4.49381 37.1265 21.8421 33.1234 -31.7004 -39.5319 +7534 4 4.78916 37.7556 22.4729 8.60512 21.3704 21.7375 +7535 4 5.32421 36.8863 21.3047 -36.9575 7.65083 16.8008 +7536 6 39.2568 20.1405 31.3294 -11.3601 -2.01094 -17.3558 +7537 4 39.2441 20.8952 31.9186 1.64276 10.2876 11.6417 +7538 4 38.6708 20.3662 30.5789 5.24327 3.39586 9.04201 +7539 6 28.5615 6.15748 32.0463 -1.77815 -13.6106 -5.56393 +7540 4 29.3688 6.39317 32.5024 4.03477 3.32162 5.90581 +7541 4 28.0645 6.97719 31.936 3.86184 3.53187 3.02469 +7542 6 9.32925 11.326 38.2021 -45.7357 8.82179 -18.9514 +7543 4 8.63026 12.0506 38.2047 26.1946 -20.5574 6.08922 +7544 4 8.95275 10.6938 37.5333 17.8336 11.1262 12.3014 +7545 6 41.6094 10.4714 6.86105 10.1449 -2.02989 30.4141 +7546 4 41.8033 10.1647 7.80154 -6.16714 11.7455 -31.3638 +7547 4 41.7667 11.4361 6.82819 -2.03628 -11.6206 -3.02795 +7548 6 3.11959 28.1093 17.6239 10.7497 -46.175 24.4008 +7549 4 2.68352 28.5892 16.9552 -19.7085 26.1099 -29.6067 +7550 4 3.57016 28.7359 18.1797 1.91623 14.188 4.79643 +7551 6 39.3448 12.237 19.2548 -14.1137 14.4353 18.1644 +7552 4 39.3198 13.2124 19.4672 -0.23776 -25.4214 -5.72266 +7553 4 38.5957 11.8144 19.7397 13.7352 7.639 -10.0067 +7554 6 2.76578 9.12322 31.711 10.2249 -26.7767 20.5709 +7555 4 3.2959 8.42892 32.18 -23.1647 11.967 -1.06293 +7556 4 3.41205 9.47362 31.1162 6.35119 16.2437 -14.7539 +7557 6 47.0978 34.3186 24.1743 26.4285 -20.6373 22.1669 +7558 4 47.9222 34.8155 23.9694 -26.3889 2.76484 -4.38573 +7559 4 46.3048 34.7125 23.8251 -6.69439 19.4391 -11.1209 +7560 6 41.2781 35.6191 9.5379 -9.82526 -0.200667 -5.59214 +7561 4 40.3156 35.6289 9.77314 20.3165 9.2235 -0.933793 +7562 4 41.677 36.5159 9.62264 -17.3348 -12.0484 0.717846 +7563 6 20.4662 31.4486 3.15039 -21.7086 3.64016 -5.07598 +7564 4 21.0332 31.2208 3.90109 -5.23001 0.711793 3.99895 +7565 4 19.5233 31.6154 3.43158 26.7394 -6.53789 -0.258783 +7566 6 33.2215 17.9623 24.8097 -0.453891 -1.34226 7.30289 +7567 4 34.1788 17.9667 25.0617 -18.0356 9.24084 -3.8919 +7568 4 32.8105 18.8566 24.8334 12.2893 -13.6267 3.75162 +7569 6 40.152 39.887 35.7648 -20.6867 7.32712 26.7748 +7570 4 39.5869 39.7633 34.9934 2.3303 1.35559 2.0998 +7571 4 39.5428 40.1203 36.5292 18.9615 -7.74514 -25.9591 +7572 6 4.86846 34.7127 16.4904 2.99496 1.45153 -7.51648 +7573 4 4.94748 35.6438 16.2302 0.473437 -5.16658 -0.520329 +7574 4 5.67201 34.2663 16.1683 2.12015 0.152524 1.06444 +7575 6 19.1332 11.0374 26.5471 0.604362 14.7011 2.3555 +7576 4 19.0986 10.7741 25.6217 -2.73437 -5.06461 -1.05922 +7577 4 19.4813 10.3027 27.0576 -1.53582 -10.5153 -0.687646 +7578 6 54.0201 13.9196 34.7874 -7.69802 -2.07317 -2.05829 +7579 4 53.0764 13.9769 34.9536 -3.33021 -5.1824 4.14914 +7580 4 54.0417 14.262 33.8952 13.8623 5.56658 -9.2157 +7581 6 1.84699 20.6587 5.20972 14.9439 0.361847 -39.2318 +7582 4 1.3018 19.9191 4.88605 -0.816153 4.45331 11.6833 +7583 4 2.38828 20.8916 4.39492 -13.6739 -1.13034 29.3331 +7584 6 22.2428 0.0912174 14.2544 2.10511 -1.36215 24.2926 +7585 4 21.4939 0.626329 14.4934 -11.4394 6.88953 -7.77601 +7586 4 22.6568 41.86 15.1175 2.53583 -3.69112 -10.285 +7587 6 4.95629 7.04242 24.7427 6.31781 -9.23371 -7.19194 +7588 4 4.17782 7.32111 24.2434 0.969413 4.1364 5.47863 +7589 4 5.24611 6.21648 24.3187 1.32276 5.05146 9.71893 +7590 6 41.4805 20.8726 34.9438 -11.2314 22.7349 11.4525 +7591 4 42.1022 20.1554 34.9949 12.4759 -11.6791 0.0999164 +7592 4 41.5325 21.3468 35.8092 3.20944 -13.6901 -15.0483 +7593 6 28.2157 1.74547 31.725 -9.95228 -2.94536 5.02618 +7594 4 27.5723 1.08944 32.0352 4.54694 0.234407 -12.282 +7595 4 28.3302 2.26918 32.5198 6.68924 9.49254 2.75715 +7596 6 16.8899 27.3746 36.9858 -9.49677 -4.03922 3.2671 +7597 4 17.2157 28.1459 36.4964 2.86939 -7.49192 -2.31982 +7598 4 17.0938 26.5386 36.5152 1.89463 15.2676 -1.69393 +7599 6 26.8243 38.069 8.34482 13.7761 41.6132 3.1747 +7600 4 26.4823 38.3279 9.22598 3.84792 -18.6223 -11.4711 +7601 4 26.785 37.1424 8.19579 -7.88027 -37.9853 9.71444 +7602 6 26.6634 33.7911 23.2273 -21.2745 -8.43567 7.74896 +7603 4 27.1019 33.3181 22.5212 7.04537 -0.372104 -6.32159 +7604 4 27.3305 34.169 23.7872 14.5385 6.50935 5.10733 +7605 6 10.2166 27.1183 30.2276 16.2509 -17.1331 -9.46175 +7606 4 10.1765 28.0583 30.3796 2.29392 15.9864 2.71565 +7607 4 10.9387 26.9511 29.5696 -14.5483 8.58048 15.0042 +7608 6 47.87 12.5975 5.02268 -6.13754 10.9902 -1.31963 +7609 4 48.1357 13.4822 5.34438 -4.36861 -17.8106 0.719643 +7610 4 48.2725 11.9144 5.56853 6.38614 1.6905 7.47062 +7611 6 53.3393 24.5639 22.1523 -40.2275 -1.43509 1.91788 +7612 4 53.1884 24.513 23.11 6.12251 -0.709171 0.80005 +7613 4 54.2538 24.6676 21.944 28.1496 2.10984 1.66559 +7614 6 29.4072 10.7569 19.3822 52.4151 15.8336 -9.71081 +7615 4 29.248 9.98119 18.8618 -10.0643 -15.3346 -6.0739 +7616 4 28.6282 10.9567 19.8417 -45.3483 4.87471 22.9978 +7617 6 39.4757 14.9522 19.5461 30.0359 -1.30311 42.0602 +7618 4 40.386 15.231 19.9108 -38.5728 -7.77311 -23.4682 +7619 4 39.3498 15.357 18.6983 1.75067 15.7407 -16.9704 +7620 6 32.8823 15.9838 22.806 -0.988113 9.61369 -4.64335 +7621 4 32.9657 16.5376 23.5815 3.43203 16.8704 5.79609 +7622 4 32.7087 15.1359 23.1895 -5.55033 -22.0541 3.57771 +7623 6 30.5481 1.96835 21.5144 8.4955 -1.31523 7.25762 +7624 4 30.7645 2.06729 22.4547 -1.5525 1.72807 -3.05596 +7625 4 31.3563 1.607 21.1075 -12.3766 3.94884 0.453046 +7626 6 0.972615 11.9937 3.31932 2.75381 16.0475 9.69945 +7627 4 1.12058 12.9582 3.29011 -6.67466 -9.20629 -8.78254 +7628 4 1.16803 11.7633 4.23669 1.49118 -7.35844 2.879 +7629 6 32.1487 30.4035 20.7885 -10.2937 2.79415 -8.64413 +7630 4 32.9584 30.6778 20.3377 1.19491 2.22071 -1.75985 +7631 4 31.4018 30.7106 20.2304 12.8433 -5.61998 7.3235 +7632 6 5.36663 35.5196 9.0005 -13.7636 -10.8617 -1.51226 +7633 4 5.10558 35.6694 8.09522 3.88385 7.21083 -8.97177 +7634 4 4.84313 34.7327 9.21079 3.19207 0.561776 9.20467 +7635 6 49.9075 13.051 32.2032 24.7068 -1.78611 -22.7634 +7636 4 50.5917 12.8604 31.4934 -20.1594 10.2365 23.451 +7637 4 49.3072 12.3042 32.1357 -5.12737 -3.80929 6.93874 +7638 6 4.31321 24.0956 1.58545 -15.4175 -15.0012 -21.2972 +7639 4 3.62325 24.7374 1.73273 -2.73087 12.0747 8.21305 +7640 4 3.96758 23.5799 0.823479 15.3265 9.07188 13.8923 +7641 6 44.1581 38.1227 12.3545 -1.42535 -29.4608 0.820402 +7642 4 43.4877 37.5183 12.7749 7.78878 22.0847 -6.23147 +7643 4 43.9706 39.05 12.5061 -8.83193 8.8938 6.46859 +7644 6 44.688 17.3349 22.7943 52.857 -4.21013 7.29678 +7645 4 45.2391 18.0521 23.242 -20.6522 -19.8992 -14.1432 +7646 4 45.3699 16.6167 22.57 -26.4285 25.231 9.0384 +7647 6 20.3608 11.6914 19.667 7.58964 -15.1508 -20.1027 +7648 4 20.0231 12.466 20.0832 -9.22037 21.7722 17.9466 +7649 4 20.541 12.011 18.7627 0.78957 -9.8802 4.31695 +7650 6 4.45783 15.4051 36.2022 4.17523 -10.6616 -1.13379 +7651 4 5.07913 14.7124 35.8925 -4.22209 9.46347 0.0108161 +7652 4 3.57023 15.0045 36.1544 3.18966 5.51307 1.04981 +7653 6 44.8105 39.5245 30.1712 -12.2097 -12.5983 -29.4865 +7654 4 44.6649 39.2374 29.2388 12.2423 8.81859 19.2473 +7655 4 44.0848 39.0946 30.6384 -0.298867 5.38951 7.86823 +7656 6 30.0635 3.50956 11.3278 16.0802 -2.39158 -40.3094 +7657 4 30.5444 4.30508 11.007 -11.8296 -5.04519 20.5985 +7658 4 30.1379 2.92562 10.5291 -8.6007 1.99314 24.6663 +7659 6 25.6288 24.8657 16.1423 35.3146 -5.68436 -0.158812 +7660 4 26.5897 24.7732 15.9989 -9.69879 -4.30362 -13.2764 +7661 4 25.6615 25.1054 17.0605 -14.6317 7.6504 23.2411 +7662 6 36.8074 29.8609 20.6529 -16.3286 -4.81766 17.6852 +7663 4 35.9316 30.2459 20.3982 14.0867 -8.19012 9.60149 +7664 4 36.7164 29.3161 21.4988 -1.56746 21.2483 -31.978 +7665 6 52.2273 17.0565 38.3075 -18.6216 -30.1938 15.1193 +7666 4 51.4912 16.4635 38.6201 23.7372 14.7716 -7.00173 +7667 4 51.7959 17.5937 37.6524 -0.777677 7.661 -6.77585 +7668 6 3.82637 23.6296 29.8591 26.0466 24.015 14.1033 +7669 4 4.67122 23.3872 29.4436 -4.98409 -4.75234 -2.50433 +7670 4 4.14214 24.3103 30.5173 -20.0237 -17.5461 -14.7603 +7671 6 6.36694 19.9104 41.0994 -7.87156 6.69529 -0.551213 +7672 4 6.75531 19.2216 41.6418 3.91706 -4.8357 7.00798 +7673 4 6.43687 20.7189 41.61 0.371167 5.3541 9.12827 +7674 6 28.9069 38.9219 35.3342 18.1363 5.4885 19.4373 +7675 4 28.4975 38.2544 34.8057 -13.0204 -17.6003 -18.1497 +7676 4 29.7244 38.4883 35.6529 -6.84193 6.3312 -4.3373 +7677 6 1.06391 30.294 34.4744 17.4659 -4.25802 33.126 +7678 4 0.923806 29.8092 33.6831 -4.92213 -16.9626 -31.6436 +7679 4 0.43107 31.0027 34.4841 -13.3738 11.5818 -2.38269 +7680 6 26.4433 22.0338 20.438 10.4135 -19.5508 3.73058 +7681 4 27.3849 22.2767 20.3653 -17.5193 8.20183 -1.91668 +7682 4 25.8117 22.75 20.2981 5.30742 7.62512 -2.77887 +7683 6 3.9439 18.647 22.686 19.6053 -30.212 14.064 +7684 4 4.76982 18.631 23.2404 -22.0254 9.00566 -12.7221 +7685 4 3.71052 19.5535 22.5456 -1.30938 28.7031 -1.82281 +7686 6 6.87955 39.3273 26.9921 -1.67667 -12.9446 -11.9216 +7687 4 7.1836 39.9129 27.6984 -12.429 3.42242 7.34442 +7688 4 5.90054 39.2886 26.9896 13.9064 15.8094 12.8698 +7689 6 43.976 41.7556 26.5281 4.8347 -4.89589 -5.39334 +7690 4 43.9038 0.242071 27.3891 4.48323 5.1383 20.2804 +7691 4 43.1144 41.9148 26.1591 -17.5097 2.26447 -13.804 +7692 6 31.7137 29.57 16.9845 -29.8695 1.84649 5.70955 +7693 4 31.0051 28.8814 16.8861 15.511 13.0746 -1.88966 +7694 4 31.2475 30.3377 17.3963 12.872 -19.7765 -2.8161 +7695 6 46.2467 10.9544 15.5549 14.6537 -15.0388 13.4913 +7696 4 45.2992 10.7621 15.4719 2.35584 -6.3837 2.44855 +7697 4 46.7422 10.1008 15.6673 -18.7057 18.8904 -8.1417 +7698 6 36.5806 15.025 25.8165 21.8026 1.76557 9.13915 +7699 4 37.3648 15.4873 26.2149 -21.7037 -15.0217 -10.3096 +7700 4 36.1201 14.6319 26.5704 -2.31195 -1.95921 2.19148 +7701 6 47.2758 22.6707 6.12549 -20.393 21.5378 -17.5673 +7702 4 46.5536 23.2672 5.80637 16.9751 -15.6011 5.88158 +7703 4 47.0174 22.4855 7.02503 2.56882 -3.04752 8.65489 +7704 6 27.5281 39.6653 17.8063 9.11062 13.5998 -14.667 +7705 4 26.6008 39.6971 17.5421 -9.18871 -3.65478 0.40423 +7706 4 27.5952 39.1072 18.5692 -4.91094 -8.97362 13.813 +7707 6 14.0432 27.9674 36.8911 6.42031 -13.692 3.20322 +7708 4 13.4093 27.2386 36.6831 22.3711 16.0651 -1.21324 +7709 4 14.9745 27.6178 36.9209 -23.5128 3.35359 -2.56993 +7710 6 33.7582 13.0225 13.8549 2.82411 10.3644 -10.1378 +7711 4 34.6192 13.1187 13.3682 -26.1927 -14.0119 11.7219 +7712 4 33.447 12.1034 13.9061 16.5995 3.21583 -3.74575 +7713 6 3.39066 17.4794 1.96807 -11.027 -24.2448 -29.9928 +7714 4 3.01559 16.7425 1.36999 17.4474 35.7284 24.3857 +7715 4 3.43148 18.2603 1.39088 -0.910914 -5.0095 5.82543 +7716 6 27.5636 2.76805 36.4448 23.3016 6.40537 7.49337 +7717 4 28.0874 2.94382 35.6362 -14.0128 -4.70143 5.95918 +7718 4 26.7201 2.39292 36.1778 -1.1877 -0.145823 -5.22631 +7719 6 21.3174 1.20043 18.721 3.60184 -34.5623 26.1973 +7720 4 20.9731 2.06802 18.64 -8.90193 33.3239 -10.7294 +7721 4 20.989 0.903829 19.6038 6.52339 -1.5964 -17.0558 +7722 6 11.8953 16.678 29.2972 -24.0209 -12.1876 15.7906 +7723 4 10.9907 16.5502 28.9196 20.2967 4.53139 4.03679 +7724 4 11.83 16.2797 30.2084 5.50538 14.3948 -24.2902 +7725 6 15.9723 29.4609 29.6333 0.682268 26.1612 18.9471 +7726 4 16.8848 29.3174 29.3467 -1.47573 8.2327 2.84191 +7727 4 15.9822 30.2485 30.2615 3.64459 -27.0302 -18.4378 +7728 6 42.9269 7.03734 4.5197 11.663 -6.03152 6.53833 +7729 4 43.4231 7.50219 3.8104 -1.91258 -11.2042 14.7177 +7730 4 43.564 6.5391 5.10838 -14.9069 13.4822 -19.2581 +7731 6 46.4099 26.3175 18.5001 -14.65 2.77244 -10.2078 +7732 4 46.6739 27.1133 19.0164 -10.4759 -17.1195 -12.5948 +7733 4 45.7242 26.5969 17.8403 16.3643 -1.95791 15.5671 +7734 6 26.8576 31.9381 30.1176 11.4414 -26.9795 -35.8502 +7735 4 27.1259 30.9869 29.8859 -9.79711 36.6724 15.314 +7736 4 26.5998 32.3006 29.2227 5.46388 -10.7605 29.9307 +7737 6 19.4818 37.6192 31.2596 -32.5143 -22.3469 33.0613 +7738 4 19.0962 36.8501 30.8088 8.72557 8.52431 -5.84089 +7739 4 19.0944 37.5229 32.1795 16.9146 13.3756 -22.466 +7740 6 52.3665 32.7318 12.7942 -5.34222 7.33615 -3.08781 +7741 4 51.884 32.8768 11.9489 17.9119 0.95058 7.1847 +7742 4 53.27 33.1068 12.8183 -18.0778 -3.45769 -11.3622 +7743 6 6.73992 9.26339 24.0285 -18.4022 -33.2824 -0.456279 +7744 4 6.43016 9.52976 23.1488 2.39009 0.543925 -1.37305 +7745 4 6.14044 8.50785 24.2751 15.0572 15.2043 -3.93749 +7746 6 39.7373 39.5658 25.499 -11.0807 -5.52867 0.517577 +7747 4 39.7453 38.628 25.2585 2.77876 5.57729 -0.31401 +7748 4 38.826 39.699 25.8216 4.65786 0.889055 -1.26295 +7749 6 24.0734 14.0105 21.1438 13.9648 5.3121 -25.5312 +7750 4 23.6065 13.6215 21.8839 -3.42696 -11.6299 6.48748 +7751 4 24.3304 13.3134 20.491 -9.48085 14.6929 20.6508 +7752 6 5.1987 41.7736 24.8713 10.0047 -19.0707 10.1325 +7753 4 6.05769 0.0475547 25.2635 0.547146 -1.74599 -5.91735 +7754 4 4.86042 0.69526 24.5593 -4.41349 12.4443 -5.8689 +7755 6 42.3687 20.86 21.2777 19.2234 -22.1312 -1.40502 +7756 4 42.3783 20.5581 22.1846 0.624409 -1.73106 8.2154 +7757 4 41.7113 21.532 21.2665 -20.5735 20.428 -5.9858 +7758 6 48.2425 15.3687 33.5924 -0.241089 -2.38933 -5.28694 +7759 4 48.6415 14.7162 33.0072 6.18243 -4.87195 3.86709 +7760 4 47.6596 15.8553 33.0028 -7.11438 7.34599 -0.780278 +7761 6 46.0202 38.2953 16.5865 15.7829 17.4793 7.01852 +7762 4 46.7193 37.7552 17.0318 -13.8218 15.7663 -8.05182 +7763 4 46.1673 39.253 16.8241 -2.73609 -24.364 -6.22008 +7764 6 4.62701 28.4898 21.3631 -35.4199 -38.8764 -1.71187 +7765 4 5.05003 28.7578 22.1614 14.3175 13.903 20.3467 +7766 4 4.23296 27.6059 21.6238 11.0236 23.568 -16.8729 +7767 6 20.5692 15.1618 18.3974 -2.72234 -3.16682 18.7699 +7768 4 20.0205 15.9086 18.1633 -0.374776 9.93651 -8.10169 +7769 4 20.1114 14.8073 19.1799 7.71486 -3.14336 -3.02048 +7770 6 16.2446 13.6415 17.4737 -35.4034 4.06645 -23.9936 +7771 4 16.1835 14.6144 17.5029 6.20848 -12.1 -0.082548 +7772 4 15.5556 13.4035 16.7727 24.4056 2.85778 27.0666 +7773 6 52.5084 30.9566 18.1567 -0.97573 -12.5044 17.346 +7774 4 52.0533 31.4717 17.4985 -6.50351 10.4198 -16.9401 +7775 4 51.7821 30.6074 18.6971 11.4062 2.54252 -4.46582 +7776 6 24.418 1.73203 15.7939 2.07222 -10.1482 7.47229 +7777 4 24.2447 1.14878 16.5739 0.390494 16.7143 -9.44633 +7778 4 24.1366 2.64887 15.952 -0.929678 -6.23215 5.34629 +7779 6 23.8719 5.08832 31.0744 22.7283 -21.9769 -16.2257 +7780 4 23.8146 5.92648 31.5054 -7.3092 22.9653 9.22328 +7781 4 24.8319 4.92382 30.9303 -16.6577 0.531409 1.66203 +7782 6 29.6615 30.9343 0.410524 16.5859 -5.2272 -6.83283 +7783 4 30.4171 30.5602 -0.0763344 -8.98044 0.909776 12.9407 +7784 4 29.1293 31.2514 41.5907 -13.3941 8.54792 -1.14443 +7785 6 32.8591 37.9003 22.5268 -10.9299 -3.56267 -2.34485 +7786 4 33.7082 38.1164 22.1304 5.81458 1.66065 7.83892 +7787 4 32.835 38.1832 23.4516 6.53001 6.08896 0.386172 +7788 6 16.4762 17.3653 33.758 -11.7596 5.685 -6.41316 +7789 4 15.9639 18.0545 33.2621 15.6067 -10.6469 10.7903 +7790 4 17.1589 17.009 33.1621 -6.01342 7.59956 -1.04496 +7791 6 9.22918 13.3839 27.5418 -13.213 -9.30661 16.5651 +7792 4 8.30942 13.5198 27.2923 -4.71042 4.84624 -13.6557 +7793 4 9.0972 13.1179 28.4658 14.0632 -0.809421 3.61995 +7794 6 43.4685 7.73978 17.2176 -8.6426 5.21856 8.44668 +7795 4 43.4054 7.77113 18.1985 3.14312 -1.73226 -22.4674 +7796 4 44.4071 7.82788 17.0033 -0.931382 -0.0897333 1.197 +7797 6 22.3132 24.3412 23.1703 -9.75348 13.1727 -0.0757149 +7798 4 22.7871 23.5122 23.2675 1.8966 -9.89464 -1.11237 +7799 4 21.5045 24.1854 22.6454 4.5924 -1.52242 4.18414 +7800 6 26.0037 32.9236 32.716 -4.33416 -0.788049 -7.61174 +7801 4 26.2455 32.6516 31.8136 -0.0498336 0.850388 -0.133699 +7802 4 25.1949 32.4304 32.9126 -0.360701 -0.787143 2.76329 +7803 6 16.9426 19.041 7.45715 -3.10994 24.472 -2.41526 +7804 4 16.308 19.3093 8.14456 3.13816 -6.91205 -2.30089 +7805 4 17.0114 19.8381 6.87129 1.57938 -24.3813 10.2947 +7806 6 48.1131 14.4569 27.5699 7.08917 8.35207 6.49885 +7807 4 48.0603 15.1245 26.8691 -1.5138 -4.18476 1.16992 +7808 4 48.1537 14.9494 28.4126 -1.96213 -3.76556 -9.73571 +7809 6 52.3834 41.7541 11.1123 -0.447482 12.3 22.2377 +7810 4 52.3153 0.228199 10.2442 -0.817032 7.00513 -16.5207 +7811 4 52.6623 0.571857 11.7011 -4.41087 -5.87968 -8.23494 +7812 6 36.3325 6.93202 12.7048 -8.66608 5.7588 -1.53482 +7813 4 36.3873 7.88419 12.9074 5.41886 -9.49824 0.0534512 +7814 4 37.2464 6.6206 12.6662 3.93968 -0.5832 -0.272047 +7815 6 8.24609 20.3242 16.6676 2.28714 -8.73249 -3.11806 +7816 4 7.99607 19.3797 16.5602 0.915774 9.85224 4.30221 +7817 4 9.21956 20.3717 16.6442 -3.81833 -2.78155 -1.09608 +7818 6 28.8059 40.3215 12.8316 -6.32157 -2.99739 9.80695 +7819 4 29.5356 40.2333 12.2314 15.0973 -2.52646 -11.1155 +7820 4 28.4555 39.4209 12.8947 -4.4969 5.39171 3.74805 +7821 6 18.1648 11.8204 16.9538 6.42365 10.4423 10.6103 +7822 4 17.6537 12.6149 17.1793 -7.21931 -10.1359 -1.31065 +7823 4 19.063 12.1656 16.925 9.05203 -3.86377 -1.18548 +7824 6 30.8803 17.4233 21.4874 -38.9186 -21.5127 -11.6054 +7825 4 30.1793 16.7188 21.4067 15.4039 25.3522 4.50617 +7826 4 31.5864 16.9116 21.8642 20.5617 -1.86838 10.7411 +7827 6 34.8073 19.4112 37.959 10.4013 19.2527 -16.7989 +7828 4 34.9062 20.1671 37.3279 -0.177011 -16.5385 16.965 +7829 4 34.2544 18.768 37.5084 -3.31564 -7.45818 -3.12702 +7830 6 35.8251 16.8879 29.2053 19.9429 8.12055 25.1888 +7831 4 36.604 16.4922 29.6427 -6.21008 5.15879 -2.88988 +7832 4 35.5164 16.1914 28.6524 -12.7517 -21.289 -18.0185 +7833 6 3.03682 32.2806 6.33235 -9.22618 28.6071 10.2197 +7834 4 2.10307 32.1357 6.11945 6.4331 -12.4482 -1.5948 +7835 4 3.56193 31.5065 6.1559 2.8275 -21.5224 -7.32445 +7836 6 26.8 41.6522 10.1614 16.4152 -10.6242 6.62789 +7837 4 27.6763 41.4103 9.75871 -19.2491 6.11251 13.5217 +7838 4 26.9685 0.0827479 11.0562 4.26354 0.263175 -7.76775 +7839 6 52.2755 24.564 24.8743 -17.4742 4.09161 11.4913 +7840 4 51.3068 24.6875 24.9545 12.6777 -6.48001 -7.54331 +7841 4 52.5704 24.9086 25.7267 7.88636 1.59704 3.61539 +7842 6 22.6859 22.6471 33.5865 3.00815 -0.389016 -3.70522 +7843 4 23.2377 23.2516 34.129 -18.2936 -9.34398 -1.8364 +7844 4 21.8798 22.3666 34.0572 9.18357 8.33181 5.74035 +7845 6 10.6559 14.2334 33.0439 8.40108 -6.88321 -2.71679 +7846 4 10.5166 14.9368 32.4181 8.42324 10.9453 -12.1325 +7847 4 9.76709 14.0756 33.3137 -17.8131 -11.8211 11.2552 +7848 6 21.913 10.8504 11.5417 10.0273 5.1408 -10.1307 +7849 4 22.8643 10.6911 11.6864 -4.5907 0.219491 7.97275 +7850 4 21.4519 10.7503 12.3817 3.5408 -3.26695 13.1151 +7851 6 38.3604 6.02409 25.8423 -7.72295 28.2176 13.9057 +7852 4 38.0159 6.28095 26.7202 2.23326 -16.155 -4.56644 +7853 4 38.4362 6.90267 25.4438 5.48615 -7.56939 -11.5178 +7854 6 30.9465 26.6393 38.5732 9.04128 -30.5088 -25.1958 +7855 4 30.9128 26.4505 39.498 -1.67119 3.99535 28.8865 +7856 4 31.0441 25.726 38.2186 -4.36445 16.9712 0.749916 +7857 6 30.1667 14.6301 35.4838 10.1392 5.1159 -4.4805 +7858 4 30.5216 15.3681 34.9096 -25.1579 -14.4294 10.0398 +7859 4 29.1929 14.5877 35.5299 11.6839 11.6021 -8.75286 +7860 6 12.5351 37.2243 16.9695 -17.9994 -5.54058 0.759354 +7861 4 12.9667 37.9067 17.4519 9.84296 27.0859 15.3185 +7862 4 13.2146 36.5653 16.9126 10.1753 -19.489 -6.1469 +7863 6 27.4306 21.5582 37.7184 0.323044 -0.91237 -2.80926 +7864 4 26.8919 21.7087 36.9418 -1.95891 -4.49412 -14.6911 +7865 4 26.9535 22.0297 38.3943 0.198826 4.23191 11.3586 +7866 6 29.6082 18.3788 12.6829 -3.7237 -11.7076 25.6006 +7867 4 29.4829 18.1024 13.618 2.9495 3.49705 -16.1413 +7868 4 28.7034 18.5321 12.3984 -4.77545 3.00323 -3.28229 +7869 6 2.3585 15.6468 0.175999 -8.20612 37.5639 57.3692 +7870 4 1.52386 15.5898 41.6501 -20.1916 -9.73007 -21.8008 +7871 4 3.00191 15.1099 41.6903 28.5072 -35.3577 -30.6151 +7872 6 17.8194 25.7234 4.22068 -18.7286 -4.35761 2.03057 +7873 4 16.8619 25.5897 3.93795 36.6055 5.10926 -2.3659 +7874 4 18.4291 25.8425 3.4621 -13.2431 -0.0346718 7.72723 +7875 6 41.7912 11.1794 20.2704 -4.7703 -4.22644 -3.97484 +7876 4 42.5222 11.2179 19.6258 -6.77094 -1.14571 2.2342 +7877 4 40.9861 11.4636 19.8126 1.73275 2.14556 -1.92771 +7878 6 38.0378 18.3863 24.0278 -3.74133 -10.331 -0.132081 +7879 4 38.4309 19.0888 24.5482 3.22643 8.24914 5.57345 +7880 4 37.9308 18.7305 23.1431 0.767244 4.53126 -6.25669 +7881 6 4.13298 13.9173 33.7521 30.6843 -35.3272 -10.2657 +7882 4 3.2388 13.7394 34.0326 -6.45696 -6.01886 0.999898 +7883 4 4.62487 13.0231 33.6052 -30.6419 39.0128 7.66426 +7884 6 19.1936 19.1847 26.5022 -1.72621 -3.50471 2.07629 +7885 4 19.5259 20.0399 26.2155 5.41694 7.89262 1.74938 +7886 4 18.9505 18.7515 25.6854 -0.500338 -7.01675 -4.74744 +7887 6 22.475 26.1945 25.3345 -21.4458 -23.9003 -3.16659 +7888 4 22.3709 25.4906 24.6814 -7.32491 -4.57374 0.352876 +7889 4 23.3013 26.5414 25.0733 33.537 19.6696 -4.44151 +7890 6 48.8098 32.073 32.5556 -12.1052 4.48194 -0.190297 +7891 4 48.9381 31.1381 32.4233 -5.03309 -16.3747 0.495313 +7892 4 49.6354 32.4434 32.2762 12.9514 12.9364 -2.07298 +7893 6 25.2177 18.014 27.013 4.13139 4.11129 3.02633 +7894 4 24.4991 17.5573 27.49 6.6231 -0.568789 -7.074 +7895 4 25.6482 17.4406 26.3525 -8.92874 -1.57445 7.95973 +7896 6 1.76475 41.5608 24.9549 2.89162 -9.06076 -21.1384 +7897 4 1.88611 40.794 24.3317 -1.07403 19.5272 24.3581 +7898 4 1.30092 0.287142 24.3881 5.67761 -7.93757 11.1942 +7899 6 18.6633 11.7702 10.8608 -14.1102 -15.1967 11.3789 +7900 4 19.5021 11.9001 10.4051 -2.67857 -1.17934 -0.0567829 +7901 4 18.6465 10.841 11.1975 0.382459 20.6246 -9.54243 +7902 6 45.6242 16.5573 4.85031 17.0541 -2.39304 -3.72853 +7903 4 46.5701 16.2411 4.85652 -23.9929 13.0597 -1.64852 +7904 4 45.6057 17.5078 4.58964 5.38323 -15.7737 4.77093 +7905 6 40.6798 36.3894 24.0177 5.99482 15.2006 -18.5281 +7906 4 40.7505 36.8152 23.1136 -3.68852 -16.1642 25.9152 +7907 4 40.7388 35.4259 23.9735 0.360603 0.79119 -4.57544 +7908 6 32.2161 36.322 4.9431 5.19197 18.2152 11.0878 +7909 4 31.5074 36.1415 4.30154 10.9387 -10.0795 -6.57323 +7910 4 33.0257 35.7839 4.88769 -13.0089 -6.05715 -7.93038 +7911 6 1.60369 14.6754 10.8168 -10.3056 7.30247 33.6992 +7912 4 2.33423 15.3134 10.9307 -7.1595 -6.86026 -1.25923 +7913 4 1.1476 14.6845 11.711 13.0511 -0.847163 -26.6328 +7914 6 35.0153 14.2871 28.0739 18.7596 2.69464 30.5166 +7915 4 34.8734 14.0618 29.0187 14.279 3.49385 -12.2543 +7916 4 34.1456 14.1907 27.7398 -26.4062 -1.19123 -20.5956 +7917 6 54.7157 6.11907 21.8609 -12.1949 -7.16094 1.89291 +7918 4 53.7846 6.03827 22.1577 10.7478 1.95047 -3.13077 +7919 4 0.0370646 6.90146 22.3147 2.89466 7.98076 3.79048 +7920 6 31.7642 16.9274 27.3665 -7.54316 -5.52924 6.90942 +7921 4 30.8348 17.1206 27.2023 -9.34166 0.83246 -0.0222557 +7922 4 32.1928 17.2544 26.5838 13.9998 7.82105 -16.2222 +7923 6 14.4504 28.0052 11.1087 -4.71237 -14.6735 4.6077 +7924 4 14.1081 28.8557 11.3451 -9.65694 14.7183 8.34222 +7925 4 14.826 28.1745 10.2406 5.25389 -7.26775 -5.19981 +7926 6 35.6627 19.4906 18.309 1.38743 3.66357 1.00844 +7927 4 36.0608 19.4502 19.1905 -8.3289 1.62604 -1.04031 +7928 4 34.971 18.8114 18.299 7.41978 2.58016 -0.85803 +7929 6 0.908295 12.7232 15.4509 -10.2874 -45.1283 5.64528 +7930 4 0.635795 11.7526 15.3361 10.0925 35.0181 2.47128 +7931 4 1.39513 12.719 16.2997 -3.76012 1.73199 -7.91518 +7932 6 52.7239 14.8052 20.9911 -10.1838 -50.8962 13.8805 +7933 4 52.1355 13.9729 20.9263 20.4043 37.1153 -0.0771148 +7934 4 52.3678 15.481 20.4204 -9.75671 2.85516 -9.21068 +7935 6 7.50014 6.78453 13.6112 45.6118 -3.77462 -0.237279 +7936 4 7.66407 7.72531 13.7166 -11.095 5.64184 -2.33744 +7937 4 8.44113 6.46934 13.5548 -33.3093 -4.56257 -1.46213 +7938 6 12.8693 29.1327 30.951 -35.1999 43.7452 -37.9705 +7939 4 12.911 28.5157 30.2274 6.73286 -14.9776 0.757022 +7940 4 13.2432 28.8129 31.7306 26.8069 -31.1286 39.1504 +7941 6 8.91269 29.9946 35.6682 4.82638 -20.5676 13.9142 +7942 4 9.08199 29.9869 36.6487 -3.4848 12.9743 -23.6701 +7943 4 8.85763 30.8835 35.2999 2.4913 8.97671 5.8399 +7944 6 29.2501 7.21193 5.56384 -35.3124 23.3999 -5.45769 +7945 4 29.8929 6.567 5.7677 24.3163 -25.3556 4.38867 +7946 4 28.4878 7.00912 6.14468 16.2636 8.35776 -7.44031 +7947 6 25.8882 9.2493 3.85609 -10.1418 -10.3657 2.14015 +7948 4 26.6938 8.77544 3.58522 -5.62061 -1.52714 -0.987441 +7949 4 25.143 8.71761 3.5088 14.4855 4.13341 2.07026 +7950 6 46.1828 19.5303 23.8452 27.5142 -8.79556 18.2338 +7951 4 47.0303 19.3932 24.4147 -29.6641 11.3761 -34.952 +7952 4 46.4302 19.9015 22.9687 10.0609 -5.49214 13.8961 +7953 6 18.6 35.3226 28.7813 33.9262 -21.2248 5.29661 +7954 4 18.5078 36.1255 28.2543 2.15121 5.76995 -5.3877 +7955 4 19.5645 35.0126 28.755 -37.0827 17.274 -2.06568 +7956 6 28.0068 22.625 32.1882 17.1638 -9.71048 -11.652 +7957 4 28.1161 23.0799 31.3381 -0.933036 0.686599 6.01892 +7958 4 27.1717 22.9224 32.5558 0.319614 0.839726 2.26602 +7959 6 25.9992 18.4251 22.6716 -8.51512 -6.6596 14.3523 +7960 4 26.8098 18.8237 22.3895 20.3106 6.57833 -11.9809 +7961 4 25.8253 18.8771 23.5162 -1.041 -7.57666 -6.79729 +7962 6 31.1689 23.0872 29.1831 -2.26749 -18.4759 6.78914 +7963 4 31.118 22.1592 28.8841 -5.05583 5.59361 3.05947 +7964 4 31.7418 23.5345 28.5581 5.1573 7.79625 -4.49352 +7965 6 36.6391 4.9259 0.480345 37.9344 10.2065 -26.5572 +7966 4 36.638 5.82198 0.886244 0.658013 -14.6584 -5.92388 +7967 4 37.39 4.95173 41.699 -35.1456 1.42767 30.4358 +7968 6 36.484 21.0145 10.0529 -6.00883 6.48187 8.17175 +7969 4 36.4042 20.1763 9.58301 3.63574 2.58382 -3.15576 +7970 4 35.8773 20.9259 10.8015 2.14778 4.06152 -0.936887 +7971 6 50.5993 25.1947 18.3919 -28.2028 12.9956 8.35013 +7972 4 49.869 24.7394 17.9262 9.19638 1.46827 3.55355 +7973 4 51.4482 24.8993 18.0848 11.0575 -8.08323 -5.33222 +7974 6 50.1824 39.6576 12.4356 -22.7811 -7.9912 15.1349 +7975 4 49.7705 38.7879 12.6194 4.75387 11.043 -2.88475 +7976 4 51.0686 39.4751 12.1603 15.8621 -1.53988 -6.37666 +7977 6 30.5412 12.4178 4.80566 -15.3128 -2.78075 25.3711 +7978 4 30.0752 11.5776 5.01806 10.6669 11.6172 -5.90727 +7979 4 31.021 12.2424 4.01172 11.531 -8.83371 -18.4272 +7980 6 28.9525 15.4713 21.8679 -2.36978 -36.4192 26.6063 +7981 4 29.1677 14.6271 22.3934 -7.66269 33.2693 -19.6276 +7982 4 28.1632 15.8063 22.3348 7.54721 -2.84859 -11.2752 +7983 6 14.0684 9.5583 16.997 2.7235 -6.59901 -0.744295 +7984 4 14.8185 8.94582 17.0717 -0.0957791 5.7783 -3.11218 +7985 4 14.4323 10.4488 16.9992 1.00571 2.57913 -1.39277 +7986 6 4.48903 30.1743 11.858 18.777 -10.7052 13.2768 +7987 4 4.86699 29.7697 12.6847 -17.3276 7.96894 -17.1216 +7988 4 3.53137 30.2861 11.9207 -0.113543 -0.314347 4.01346 +7989 6 40.8874 8.0652 23.6541 0.993335 -18.0149 -24.6412 +7990 4 41.0014 8.23968 22.6934 -0.45004 7.6784 15.1082 +7991 4 40.7726 7.0925 23.6399 1.20374 9.92563 8.58777 +7992 6 53.7462 35.0557 16.7061 9.98011 -4.48961 -22.2856 +7993 4 53.4827 35.8182 17.2307 0.000554802 6.10184 -1.96461 +7994 4 54.0786 35.3449 15.8213 -7.68991 -0.599931 23.4559 +7995 6 53.7073 10.1889 20.3718 -10.7517 16.2467 -19.4493 +7996 4 53.8408 10.0262 19.4272 8.41512 -10.415 5.03553 +7997 4 53.1338 10.9644 20.2967 0.731263 1.06205 11.7435 +7998 6 4.58979 27.075 7.78807 17.6653 -15.6715 -1.75621 +7999 4 5.19096 26.32 7.80399 16.3727 7.79792 -3.24405 +8000 4 3.78382 26.6199 7.94519 -28.415 1.42755 3.38346 +8001 6 50.5066 22.5306 22.1436 -1.2339 18.6921 5.41009 +8002 4 50.2802 23.3104 22.6632 -2.8343 -11.09 7.6214 +8003 4 50.7991 22.9414 21.3369 4.56213 -7.53044 -15.8119 +8004 6 7.04346 27.196 21.628 9.41144 -9.96736 11.8657 +8005 4 6.8407 26.6883 22.4668 -8.25713 16.2835 -27.3312 +8006 4 6.26031 27.4748 21.116 4.26862 -9.43237 15.0117 +8007 6 23.8265 35.0499 16.5937 18.3012 9.13896 26.4348 +8008 4 24.7235 34.8381 16.9269 -14.9485 7.62278 -2.13189 +8009 4 23.7604 34.5968 15.7714 -3.77201 -11.7597 -22.7393 +8010 6 5.98953 23.8983 3.91761 -44.4181 -14.5448 -1.98234 +8011 4 5.398 23.9519 3.1318 15.794 0.401012 8.45254 +8012 4 5.35617 23.6012 4.61938 19.6174 4.72778 -5.04958 +8013 6 38.7401 25.0729 19.1247 8.8169 4.91643 10.7802 +8014 4 38.7862 24.2921 18.5681 -1.99613 -8.272 -9.94687 +8015 4 39.0639 24.8191 20.0061 -2.94522 4.87881 -4.09917 +8016 6 12.9717 18.2893 10.6182 7.92512 -8.05782 -7.58833 +8017 4 12.0999 18.3162 10.2013 -2.76008 2.25331 1.21984 +8018 4 12.8722 18.6085 11.5165 -3.68712 5.29275 10.5515 +8019 6 38.0382 41.2423 21.0873 4.88219 -19.6272 -0.152698 +8020 4 37.2014 40.7765 21.2484 2.63704 8.02432 -2.02816 +8021 4 37.8835 0.198079 20.7163 -11.2369 15.8096 -5.69312 +8022 6 6.98214 22.8682 17.8394 -5.75247 -17.9204 -1.57462 +8023 4 7.61723 23.542 17.6412 15.6839 20.0065 -5.16874 +8024 4 7.3587 22.0484 17.4826 -2.13646 0.815835 3.23256 +8025 6 24.1186 19.368 12.3177 21.0449 6.23804 -24.2445 +8026 4 23.9242 19.844 13.1293 -4.19124 -3.15082 3.8784 +8027 4 23.743 18.4928 12.3308 -10.9397 -14.908 7.07664 +8028 6 44.2213 28.4415 4.8153 2.12167 -7.44997 -5.8313 +8029 4 44.3009 28.0649 3.91739 -1.37383 9.18016 5.99771 +8030 4 44.2294 29.4128 4.74855 1.01191 -3.53144 -7.03239 +8031 6 23.3167 8.29314 21.4338 -0.329791 14.7993 14.6131 +8032 4 22.995 9.23581 21.5362 7.25813 -26.2111 -7.67418 +8033 4 23.1349 8.01865 20.5229 -2.36131 4.58949 1.23489 +8034 6 14.3464 2.19127 18.5365 1.00479 -5.05512 -1.33996 +8035 4 14.3534 1.26337 18.7781 -10.0191 -8.45544 9.17935 +8036 4 15.2531 2.29149 18.2562 13.6881 11.5937 -7.27189 +8037 6 28.0536 31.92 34.134 3.57463 -14.0429 -1.6048 +8038 4 28.4517 32.4188 34.8607 -2.66641 5.35559 -0.0232853 +8039 4 27.3246 32.4577 33.7701 8.655 -3.68096 2.2403 +8040 6 53.3502 24.7032 18.2649 -24.2711 -41.2818 -9.83264 +8041 4 53.5194 24.6019 17.3193 6.96991 8.47211 -0.102973 +8042 4 53.68 25.5059 18.6169 17.7955 37.5084 3.34479 +8043 6 36.8031 28.4187 22.9511 -10.1554 -0.61119 21.2214 +8044 4 36.5106 28.9054 23.7358 4.15696 8.73481 -5.19311 +8045 4 36.1845 27.6911 23.0035 -2.36033 -17.8474 -9.79811 +8046 6 21.8885 30.5877 27.4793 -3.11585 8.28062 7.57241 +8047 4 22.2621 31.0993 28.2061 -3.96796 1.5816 4.48491 +8048 4 22.5937 30.5949 26.8475 10.2249 -8.24374 -18.6607 +8049 6 10.2833 3.28406 27.2289 -24.5304 -2.91212 14.6365 +8050 4 10.0443 2.76427 28.0065 14.6588 -5.9106 -2.57837 +8051 4 9.44832 3.75002 27.1066 2.80489 10.142 -13.305 +8052 6 37.7147 24.9939 29.6988 5.24245 -12.5023 -10.1121 +8053 4 38.3581 24.5533 29.0689 -23.3017 1.4918 23.5498 +8054 4 37.1779 24.3214 30.1874 12.7329 5.56421 -12.5271 +8055 6 9.13611 24.4367 14.4784 20.7258 8.96054 28.4908 +8056 4 9.04651 24.998 13.735 -5.03994 20.1658 -22.0876 +8057 4 8.726 23.6299 14.2398 -14.2121 -32.2206 -7.12291 +8058 6 52.7755 31.4643 7.39569 14.5412 -1.52098 0.484013 +8059 4 52.3413 32.1584 6.88884 0.00633314 4.2069 -4.47258 +8060 4 52.0605 30.9716 7.79316 -9.34275 -9.05133 5.36325 +8061 6 21.3287 5.44475 36.4975 17.176 -11.9485 -14.2877 +8062 4 20.7483 5.50715 37.2619 4.90115 -8.53405 7.77147 +8063 4 21.912 4.64524 36.5597 -18.1029 20.6035 4.94996 +8064 6 25.1768 37.2214 4.32574 4.31983 -25.8241 -7.35849 +8065 4 25.4326 36.64 3.57657 -1.88178 18.0132 5.09494 +8066 4 24.8685 36.5657 4.9694 -1.32139 10.7309 7.78615 +8067 6 33.9928 17.4475 18.2473 -28.4515 -0.0793518 28.5349 +8068 4 34.2921 17.0113 19.1053 -15.0281 13.9289 -20.2703 +8069 4 33.1064 17.9171 18.4165 33.1367 -21.5966 1.81969 +8070 6 37.9532 37.4932 25.2939 -37.7872 -15.4269 -20.4394 +8071 4 36.979 37.7096 25.1406 34.3292 -3.43428 9.43604 +8072 4 38.1084 36.7677 24.6487 1.47089 11.2608 10.0337 +8073 6 5.08061 4.87523 15.8431 -4.86231 -7.56388 -2.23136 +8074 4 5.78156 4.1744 15.8759 -9.54967 26.0091 2.46095 +8075 4 5.43258 5.75 16.0822 6.78608 -13.538 3.56789 +8076 6 14.1628 7.20449 7.78038 25.2379 -5.46067 -13.6381 +8077 4 13.5115 7.54153 8.36471 -22.6877 11.2017 23.85 +8078 4 13.6914 6.99143 6.96374 5.13235 0.836748 0.117842 +8079 6 24.9714 10.8522 38.0874 21.7543 24.8019 24.8971 +8080 4 25.3733 11.7327 37.9223 -2.75098 -14.513 10.3213 +8081 4 24.5811 10.6456 37.27 -22.0988 -18.3607 -37.1034 +8082 6 35.6792 7.98105 22.8098 -5.63995 -0.874411 -1.68631 +8083 4 36.3111 8.66137 23.0699 5.30437 2.23481 0.770305 +8084 4 35.3824 8.20038 21.9134 0.62108 2.61089 2.3422 +8085 6 24.7967 29.145 22.4166 8.97915 1.26062 2.6062 +8086 4 24.9285 28.4017 23.0307 -7.24415 3.31799 -2.87627 +8087 4 23.8684 29.1691 22.1667 -6.93063 -5.53381 0.128782 +8088 6 38.5003 31.6402 38.4666 0.118802 17.9484 -3.06973 +8089 4 38.5639 32.3894 37.8454 -0.598215 -11.959 -0.514206 +8090 4 38.3632 32.08 39.3134 -2.43734 -3.45212 12.1107 +8091 6 7.2246 33.2558 15.4144 3.93224 14.6297 14.7993 +8092 4 8.10558 33.3578 15.8508 -19.4169 -6.69939 -13.0108 +8093 4 7.30076 32.5035 14.7978 2.24681 10.3389 8.67702 +8094 6 43.3411 23.605 1.45378 1.24542 -6.52262 6.11498 +8095 4 43.1714 24.3501 0.858367 5.1295 -5.17404 3.37123 +8096 4 44.2208 23.7695 1.84296 -12.8059 2.13297 -8.4534 +8097 6 3.53981 32.9157 14.8686 -7.67856 -8.73615 6.98201 +8098 4 3.60397 33.2061 13.9566 0.668747 6.43783 -7.96574 +8099 4 3.81902 33.649 15.4236 5.03764 7.23473 -0.501009 +8100 6 25.308 21.7722 8.24708 3.37146 -12.406 14.7751 +8101 4 26.0573 21.1741 8.36562 1.41198 8.84323 -6.65363 +8102 4 24.826 21.6647 9.09095 -1.64121 7.89428 -12.8382 +8103 6 43.814 15.3562 17.763 -19.8802 -3.64728 -7.58039 +8104 4 43.4756 15.1225 16.8733 5.20247 0.973102 4.81929 +8105 4 44.7686 15.2775 17.7045 7.07231 -2.77487 -5.74422 +8106 6 15.7867 16.2594 16.6597 40.7179 11.0003 30.8626 +8107 4 16.4245 16.8568 16.2414 -0.344326 0.180624 1.74019 +8108 4 15.1074 16.2177 16.037 -41.8412 -2.72902 -33.087 +8109 6 31.9018 12.864 11.5221 -0.527288 11.9796 -2.61342 +8110 4 32.4715 13.19 12.2739 -15.261 0.218931 -18.2329 +8111 4 31.4408 13.5947 11.0331 13.5047 -10.6099 18.0399 +8112 6 18.2179 5.3463 10.1762 9.71532 5.2148 -18.3501 +8113 4 17.8204 5.66693 9.33813 -2.6575 -7.74782 15.1878 +8114 4 17.5556 5.18411 10.851 -9.29453 0.73034 -3.17809 +8115 6 23.0812 39.0781 10.9303 2.37609 8.25457 -4.90642 +8116 4 24.0025 38.8104 10.892 -1.10831 -0.594451 2.83356 +8117 4 23.078 39.9337 10.4697 -7.78026 -4.85412 5.47405 +8118 6 46.8678 33.747 8.76655 -5.11485 44.7451 24.4631 +8119 4 46.406 34.5339 8.40734 -0.304999 -21.98 -10.152 +8120 4 47.1603 34.1422 9.62028 2.09293 -20.2864 -11.5212 +8121 6 31.2447 39.9321 20.2226 -0.330123 -0.585472 -4.98228 +8122 4 30.8504 39.3151 19.5884 6.05804 4.05585 3.92388 +8123 4 32.2053 39.9316 20.0453 -4.95864 -1.44581 -1.12159 +8124 6 15.9016 33.0949 19.7876 25.1907 -5.52815 -22.1207 +8125 4 16.0748 33.7133 19.0349 -1.92202 -14.988 11.1016 +8126 4 16.5267 32.3265 19.6592 -15.8695 19.8556 5.2806 +8127 6 32.5654 39.9188 2.66304 17.6014 -10.2623 -15.3377 +8128 4 33.3417 39.59 3.14903 -11.9816 5.68487 0.865723 +8129 4 31.9971 40.348 3.29791 -5.42947 4.08066 9.69521 +8130 6 50.71 12.2088 3.91621 6.45352 -28.1924 -19.9843 +8131 4 51.4315 12.4725 3.33505 0.00989865 5.72461 1.55844 +8132 4 50.5782 12.8645 4.57223 -0.528152 29.464 22.8196 +8133 6 44.6954 2.75762 12.1022 0.941183 0.541095 5.21442 +8134 4 45.0772 1.91827 11.8337 7.97486 -4.13832 -5.1586 +8135 4 44.7961 2.76556 13.0748 -3.12194 1.26681 -13.8655 +8136 6 11.5119 11.9446 31.6555 0.0165034 5.87533 16.9496 +8137 4 11.2786 12.7291 32.193 1.1093 -4.42098 -1.85793 +8138 4 11.5615 11.2089 32.2952 3.49417 6.36211 -10.0029 +8139 6 4.75553 10.0442 10.5026 -0.613356 7.28818 -1.41717 +8140 4 5.04922 10.2458 11.3982 -0.190174 3.033 -2.19553 +8141 4 4.45357 10.8768 10.0827 4.22944 -8.29703 6.91569 +8142 6 17.1004 25.0221 20.585 20.8628 27.7333 -27.8469 +8143 4 16.2314 24.7196 20.7848 -24.892 -11.5638 6.73224 +8144 4 16.9745 25.5771 19.7683 4.93088 -15.3222 19.1034 +8145 6 48.1032 4.75801 14.8026 37.7024 -16.8658 7.41777 +8146 4 47.1817 4.923 14.9438 -21.3904 13.2232 -6.86149 +8147 4 48.4894 5.33532 14.1187 -17.354 1.23192 4.40994 +8148 6 18.8584 3.1094 3.41532 -17.9645 -5.092 -5.76247 +8149 4 18.4858 2.24853 3.65522 2.22195 0.198645 3.24183 +8150 4 19.7914 2.99202 3.55078 21.8001 -2.9136 1.99579 +8151 6 35.4214 26.4496 29.0479 -25.0869 -13.2406 8.30382 +8152 4 35.4596 27.2122 28.4766 3.66886 10.9927 -9.48044 +8153 4 36.2884 26.0622 29.0901 17.6032 -4.12101 -3.28535 +8154 6 32.3918 31.2203 12.8386 46.3164 14.9485 -1.56764 +8155 4 31.5927 31.2548 13.3118 -34.7781 -0.694705 18.2501 +8156 4 32.2274 30.836 11.9945 -8.46486 -12.2685 -25.2096 +8157 6 32.9972 28.3347 37.5978 -19.2694 -14.478 20.0019 +8158 4 32.1604 27.8545 37.87 25.9433 12.8245 -4.2723 +8159 4 33.4478 28.5699 38.4425 -10.0504 -3.89776 -17.7975 +8160 6 45.4943 24.785 10.3174 -24.9891 51.3938 13.5053 +8161 4 44.9436 25.3819 9.72852 18.6998 -28.2383 15.0369 +8162 4 45.6946 23.9769 9.88803 3.95472 -26.3164 -24.236 +8163 6 14.7646 31.7016 3.17106 -12.494 -4.77828 16.8956 +8164 4 14.1278 32.382 2.84257 8.55448 -13.727 9.9815 +8165 4 14.4774 31.2925 4.03575 0.781246 20.1514 -26.73 +8166 6 31.932 7.70259 4.29822 28.2629 -13.9597 32.9447 +8167 4 31.5142 6.8338 4.23667 -1.26054 0.464616 -4.26218 +8168 4 31.5893 8.26695 3.64018 -18.9284 22.0156 -31.588 +8169 6 42.5661 17.3076 32.2072 4.58091 20.9841 -12.8778 +8170 4 41.6153 17.2751 32.1225 -13.9289 -9.63208 0.974916 +8171 4 42.7549 18.1312 31.7017 7.23855 -15.1499 9.29454 +8172 6 13.801 23.1802 23.5544 20.5107 -9.18639 9.43365 +8173 4 13.5559 23.799 24.2431 -7.02941 8.57916 4.58982 +8174 4 14.6139 22.757 23.9348 -15.8084 7.21572 -12.2969 +8175 6 10.7224 7.09218 3.96878 16.2046 -14.1912 -58.7694 +8176 4 10.4615 7.01435 4.86228 -13.7845 -9.22242 34.898 +8177 4 10.4899 6.25858 3.45399 4.94204 24.1379 24.5516 +8178 6 28.7975 8.66057 17.8838 -26.4281 5.00156 -27.4828 +8179 4 29.5466 8.31163 17.3909 5.91048 -3.96826 -5.96201 +8180 4 28.1517 8.96764 17.1731 20.0585 -9.38402 22.2692 +8181 6 19.4445 29.3512 26.6402 -27.7559 12.8002 37.2849 +8182 4 18.9931 29.7086 27.4672 16.1765 -10.1498 -30.4371 +8183 4 20.3292 29.7071 26.6996 8.86807 3.45557 2.67965 +8184 6 40.676 40.9989 14.5783 -1.81287 -10.2023 17.4849 +8185 4 40.8703 41.6798 13.9303 10.8761 5.87921 -5.34291 +8186 4 41.4788 40.6754 15.0317 -0.103076 9.61372 -9.63617 +8187 6 46.2568 14.0853 31.7234 10.6503 -1.46249 4.93376 +8188 4 46.4506 13.1375 31.7184 -3.79774 3.42444 -0.601084 +8189 4 45.5065 14.2191 31.1522 -8.96365 0.976246 -7.34606 +8190 6 36.7103 36.3065 8.39844 -19.1971 -27.2559 -17.1971 +8191 4 36.3822 37.2167 8.51449 20.2374 -9.10083 14.9839 +8192 4 37.462 36.0245 8.9597 -8.83948 23.9771 2.75809 +8193 6 30.7983 32.4219 38.0908 -28.9564 1.76229 18.7871 +8194 4 31.3387 31.9445 37.476 23.2205 -2.83162 -11.1976 +8195 4 31.2894 33.1287 38.5298 9.85106 -3.61838 -6.87003 +8196 6 47.9 8.84746 10.1809 13.9026 13.2481 4.99334 +8197 4 47.2314 9.07534 9.54683 -14.9306 19.0332 -8.73943 +8198 4 48.008 7.93273 10.003 10.2061 -26.7512 4.08493 +8199 6 24.4282 17.0027 30.9766 -8.14946 0.47403 -13.61 +8200 4 23.7021 16.9118 30.3187 14.132 0.581257 9.28124 +8201 4 24.0019 17.1514 31.8341 1.66288 -1.35228 -5.87998 +8202 6 40.5039 5.09263 4.48513 -8.56504 -6.5373 -32.2613 +8203 4 41.2755 5.64065 4.37578 16.2932 9.35997 9.97847 +8204 4 40.1843 5.0523 3.55179 -2.89742 -7.45623 19.6864 +8205 6 52.5794 28.086 6.91602 -27.2154 -20.1235 6.97783 +8206 4 52.4353 28.6007 6.11552 3.94928 -0.112987 0.705634 +8207 4 51.6969 27.6552 7.08025 27.1089 14.7333 -4.60736 +8208 6 36.0629 32.381 23.6142 9.17579 -16.9148 -2.4755 +8209 4 36.5407 32.2813 22.7776 -1.15674 3.38979 7.41153 +8210 4 35.7113 33.2654 23.6252 -9.15386 11.2493 0.0331211 +8211 6 23.6552 31.8756 22.7565 -25.0136 1.00336 21.6204 +8212 4 23.73 32.5959 22.1297 15.1034 -2.64982 -11.1407 +8213 4 24.3343 31.2055 22.6866 12.2933 -0.39941 -10.0267 +8214 6 0.736598 24.4641 41.7072 -6.94393 1.55048 -19.4095 +8215 4 1.23654 24.8288 40.9522 -3.95743 -2.80997 9.51773 +8216 4 54.8325 24.2702 41.3637 13.4109 4.08216 3.5339 +8217 6 15.9721 8.97822 19.8125 19.0517 -22.613 16.6544 +8218 4 15.5497 8.29105 19.3091 -4.28185 -9.24838 -10.3339 +8219 4 15.6128 9.78815 19.5092 -16.7051 35.4763 -13.493 +8220 6 33.1656 12.5735 20.0353 32.8597 -32.3881 -24.7893 +8221 4 32.9817 11.6196 19.8453 -6.04217 28.6875 8.28399 +8222 4 34.1172 12.6638 19.7368 -32.1809 10.6792 11.3696 +8223 6 7.04894 24.9401 26.3957 -12.3425 -2.00741 -5.21086 +8224 4 6.75821 24.2907 27.0478 8.01299 -1.99342 6.24335 +8225 4 7.89161 25.3154 26.6505 10.7219 -3.29246 12.7441 +8226 6 44.479 22.5508 36.9163 -6.8399 -5.44184 13.3083 +8227 4 43.5214 22.4098 37.071 12.5044 3.3732 -3.51472 +8228 4 44.595 22.7899 36.0028 -4.86816 3.42784 -13.6235 +8229 6 39.2745 23.7032 25.1197 -32.3737 -81.7274 9.17932 +8230 4 39.5886 24.5492 24.9992 24.471 68.8814 -13.2187 +8231 4 38.7456 23.4691 24.3377 5.22396 6.33701 6.85867 +8232 6 20.3646 2.19602 36.9892 -4.85825 6.83938 3.69158 +8233 4 20.3067 1.45038 37.5971 1.4243 -8.23943 -2.36696 +8234 4 20.3942 1.88275 36.0861 3.42557 -6.35335 -2.19064 +8235 6 22.8664 19.5513 3.67104 -13.2265 5.28042 31.2857 +8236 4 22.7633 19.8561 4.6286 7.01101 -9.22167 -32.7463 +8237 4 23.7764 19.7315 3.39612 4.00916 2.85623 5.02623 +8238 6 31.705 12.5768 34.6039 18.8969 7.7197 42.0834 +8239 4 31.1026 13.3107 34.9476 21.2302 -23.3848 -5.30166 +8240 4 32.3569 12.3026 35.3493 -33.8624 17.1964 -33.567 +8241 6 12.9851 10.2105 25.0956 -25.1193 26.0078 -38.429 +8242 4 13.6149 10.0452 25.7619 22.39 -15.9831 32.7066 +8243 4 12.4963 9.40655 24.9468 1.34194 -14.9569 1.62555 +8244 6 27.2621 0.584423 13.2176 -28.6404 -16.2485 2.71576 +8245 4 27.7069 41.6292 13.1518 2.13728 8.59646 -2.51953 +8246 4 26.2847 0.395264 13.1771 23.0038 6.72582 -0.601928 +8247 6 5.66006 24.9398 13.9833 -7.43295 9.91556 10.5591 +8248 4 4.70147 24.9177 13.9802 -4.26929 -7.73667 -8.07402 +8249 4 5.82197 25.381 14.8221 8.41297 -1.15026 -0.763214 +8250 6 22.9908 17.9523 0.521723 7.02411 -25.4698 12.909 +8251 4 22.4592 18.6506 0.142784 -9.22706 3.46645 -2.83539 +8252 4 22.3527 17.3052 0.930771 13.2695 22.3169 -13.3733 +8253 6 33.0935 25.4243 5.46557 -9.38497 -10.8046 -8.60877 +8254 4 33.4966 26.2756 5.44764 14.9521 17.8538 5.01915 +8255 4 32.9941 25.2035 4.5344 -2.6207 -6.96629 2.5324 +8256 6 8.53079 7.95552 17.4804 7.64086 6.41223 -26.4035 +8257 4 9.4001 8.35547 17.2638 -9.73917 -4.33322 7.64386 +8258 4 8.4487 7.94255 18.4286 4.30191 2.70426 16.6029 +8259 6 26.8371 0.685906 2.89773 -0.256761 31.01 4.86999 +8260 4 26.7806 0.433187 3.83156 0.637082 -2.67537 2.60738 +8261 4 26.6279 1.66343 2.89109 6.9325 -26.481 -2.08778 +8262 6 50.0417 34.7142 15.6334 -23.0288 8.72534 -30.9996 +8263 4 50.5531 35.2159 14.9759 6.02412 -4.51102 12.1494 +8264 4 49.1615 34.6714 15.1751 14.0914 -5.62478 19.352 +8265 6 46.2791 4.99946 11.1196 9.7179 12.4772 -7.72995 +8266 4 45.7827 4.25534 11.4529 -10.6417 -11.5364 6.26713 +8267 4 46.9456 4.6214 10.5389 1.00953 -4.68959 -1.2994 +8268 6 33.7936 38.6123 35.3918 15.2762 25.882 47.4359 +8269 4 34.0305 39.0866 36.2411 -6.18084 -28.1229 -24.2145 +8270 4 33.6134 39.3784 34.8506 -5.42867 -1.33428 -20.4371 +8271 6 30.8282 25.8371 41.2172 -7.09757 -19.9215 -22.3179 +8272 4 31.1427 24.9253 41.375 1.19635 8.28989 4.89631 +8273 4 31.1138 26.3841 0.0263053 10.2845 10.2166 22.0109 +8274 6 50.2275 0.982033 24.4751 51.8832 -7.79127 14.7425 +8275 4 49.5671 0.561213 23.9746 -37.5145 -10.5742 -20.1648 +8276 4 51.0349 0.46072 24.2534 -17.6876 18.8276 11.0022 +8277 6 31.2908 0.710797 19.047 -2.09434 13.573 -1.22083 +8278 4 30.4487 0.672221 18.611 -14.5784 9.11804 -11.7691 +8279 4 31.2841 41.7946 19.4765 8.98672 -35.4229 20.9418 +8280 6 39.0741 29.5515 19.1276 -25.3595 -21.9961 15.137 +8281 4 38.1807 29.4949 19.565 25.109 7.94863 -12.7917 +8282 4 39.4837 28.6866 19.3452 2.49072 15.8212 -6.56848 +8283 6 21.6546 17.5955 25.8962 -6.78298 15.7545 0.118362 +8284 4 22.0482 18.4938 26.0891 -15.3421 -24.4294 -5.96834 +8285 4 20.8112 17.7106 25.4012 18.8301 2.25602 6.45745 +8286 6 35.0761 28.7988 27.4227 3.11164 -5.22767 30.3338 +8287 4 35.4099 29.4705 28.0422 -1.31539 -7.25274 0.820077 +8288 4 35.176 29.229 26.5925 2.58985 10.308 -31.8228 +8289 6 30.7102 25.4463 11.6589 -5.09223 14.513 32.8165 +8290 4 30.6059 25.8179 12.6014 3.72506 -14.6402 -39.0718 +8291 4 30.6061 26.1982 11.055 2.14208 -0.820709 7.44645 +8292 6 7.34821 15.124 12.3469 -7.98455 -28.7648 8.02815 +8293 4 6.65824 14.4547 12.1585 7.38491 7.52419 4.72727 +8294 4 7.19665 15.7511 11.658 -2.78105 24.4343 -15.0907 +8295 6 16.8417 26.815 7.05419 -24.774 6.28148 -21.5195 +8296 4 17.6138 26.5995 7.5418 30.7131 -10.23 16.3776 +8297 4 17.1302 26.9688 6.14022 -2.93816 -3.28182 4.8763 +8298 6 29.5112 33.0571 30.9901 -17.2684 21.8413 -16.809 +8299 4 28.6007 32.8494 30.6893 8.91061 -10.9491 6.08618 +8300 4 29.8939 32.355 31.5124 -6.62171 -19.0922 5.25725 +8301 6 14.1054 2.12143 30.9174 -7.90077 -11.4283 37.211 +8302 4 14.0041 2.00138 31.9209 0.0297695 4.78336 -39.0496 +8303 4 13.7376 1.30679 30.5176 6.48361 9.45743 4.44265 +8304 6 15.6593 22.2688 2.88796 -26.3773 12.8308 -8.6958 +8305 4 16.4059 21.7286 3.01985 35.1738 -16.1657 6.55343 +8306 4 15.0005 21.6175 2.62854 -10.183 2.33344 0.69621 +8307 6 23.7324 29.1178 40.9691 12.375 28.71 1.88761 +8308 4 23.2563 30.0016 40.9795 15.1309 -27.3218 0.73938 +8309 4 24.7153 29.2815 40.9372 -24.8849 -3.40565 0.339466 +8310 6 38.1289 14.1609 13.7163 11.3988 23.3452 4.961 +8311 4 37.6355 13.3641 13.8052 -15.0683 -25.2976 3.04519 +8312 4 38.877 13.9408 13.1592 7.07353 -0.711776 -7.39216 +8313 6 35.2564 26.5047 15.5196 1.21661 4.3606 12.6683 +8314 4 34.5556 26.4436 14.8616 -0.145442 -0.409522 -0.299569 +8315 4 34.9009 27.0522 16.256 4.1263 -8.75979 -17.8666 +8316 6 19.0944 34.7315 16.477 3.93496 0.874554 38.8769 +8317 4 19.5342 35.6013 16.5498 -2.87948 -9.96323 -9.99674 +8318 4 19.0181 34.4301 15.5899 3.71142 3.01681 -30.4069 +8319 6 18.1805 29.7449 35.7046 18.8444 17.1873 -3.97052 +8320 4 18.2235 30.6593 35.335 -4.4784 -20.2666 13.1463 +8321 4 19.056 29.5886 36.1261 -9.76671 1.23141 -6.47371 +8322 6 54.1188 22.2659 24.9096 4.78421 -24.6774 -19.3149 +8323 4 53.6441 21.8104 24.1769 10.121 5.11789 9.9801 +8324 4 53.5075 22.9378 25.1661 -14.3198 20.1313 5.7187 +8325 6 30.3323 10.3375 34.0061 7.35563 0.641124 -2.21855 +8326 4 29.5734 10.4043 34.5817 -14.4555 0.0376959 9.72957 +8327 4 30.8213 11.1653 34.1487 -3.17747 -4.67635 -0.590304 +8328 6 38.3211 33.8974 18.5888 -1.32754 -0.89807 -0.720993 +8329 4 38.9926 33.271 18.8539 2.22312 -19.1913 3.89796 +8330 4 38.8713 34.6655 18.5317 3.84957 24.8056 -1.31283 +8331 6 22.4809 14.1697 34.431 -22.1622 -5.27184 -37.8541 +8332 4 22.5433 13.5186 33.673 0.822047 20.8222 24.5167 +8333 4 23.1773 14.0067 35.0533 16.0768 -5.18569 10.3575 +8334 6 38.0141 0.622036 2.34694 9.03481 -5.1652 10.3599 +8335 4 37.7113 1.09641 3.1189 -18.3016 16.1314 2.00329 +8336 4 38.7028 0.120019 2.79986 6.1006 -11.8827 -16.4842 +8337 6 38.8847 41.1446 10.3004 16.8495 57.0142 -12.497 +8338 4 38.6453 0.212884 10.3117 6.47193 -33.8599 -1.337 +8339 4 38.2374 40.7573 10.8541 -26.8649 -17.5582 22.9746 +8340 6 53.4109 21.9211 38.9712 27.3607 0.0645619 -10.5759 +8341 4 53.0384 21.9801 38.0859 -10.7304 2.2749 -0.0111998 +8342 4 54.3668 22.0571 38.7395 -19.1981 -5.88632 12.9741 +8343 6 39.9872 12.7205 36.288 -8.06793 35.3321 20.4333 +8344 4 39.087 12.3834 36.3725 1.18883 -9.13664 -3.11406 +8345 4 40.4905 12.1818 35.7009 7.36107 -20.124 -19.0601 +8346 6 48.4463 17.2389 40.5967 -24.7278 4.81563 12.4078 +8347 4 47.5665 17.6971 40.4852 25.7833 -12.0744 1.257 +8348 4 48.3987 16.886 41.5134 6.10343 4.05346 -12.6042 +8349 6 32.0413 9.35688 40.0251 1.84943 -9.41379 10.5137 +8350 4 32.8011 9.3156 39.4233 -4.71533 -3.42986 0.347912 +8351 4 31.8082 8.43016 40.2864 3.98001 20.4877 -6.20043 +8352 6 31.7351 22.4909 6.36481 -11.9835 4.517 5.86255 +8353 4 31.4453 21.6589 6.79738 2.31245 15.2673 -2.59345 +8354 4 31.3521 23.2372 6.88711 4.39127 -22.2776 -7.77946 +8355 6 51.0252 2.58567 21.5888 12.0252 -3.79771 4.1956 +8356 4 51.3852 1.69652 21.8042 -1.91984 13.1306 -1.09782 +8357 4 51.7712 3.19849 21.4753 -6.25067 -9.48202 2.92476 +8358 6 13.6387 22.0486 12.1519 25.289 13.6281 9.24284 +8359 4 14.4553 22.4795 12.4841 -9.12946 -7.35477 -7.44936 +8360 4 12.9422 22.6971 12.3091 -5.69931 -0.254566 -0.690626 +8361 6 23.6098 24.0343 14.6404 -2.85842 21.3712 -30.1324 +8362 4 24.3054 24.4792 15.1401 1.72137 -5.65962 3.08819 +8363 4 23.5196 24.6041 13.8393 -4.42688 -17.9982 21.1692 +8364 6 9.32217 4.85318 31.2328 11.4746 -4.61869 -4.10735 +8365 4 8.43042 4.86168 30.8848 -9.06213 4.49291 -0.279243 +8366 4 9.25495 5.26013 32.106 -3.85952 -1.36 2.0258 +8367 6 16.6786 26.3118 18.041 -30.5179 5.83101 -14.1852 +8368 4 15.8205 26.6594 17.6987 9.23568 -14.6779 7.38956 +8369 4 17.2149 27.0871 17.9121 20.6972 11.6613 1.32787 +8370 6 5.1068 13.5155 11.5503 -9.62018 18.629 -29.2057 +8371 4 4.37741 13.3629 12.1623 -7.62379 -0.222526 0.540006 +8372 4 4.70689 13.979 10.7366 10.5209 -18.4088 37.9064 +8373 6 29.6181 23.6359 8.06142 -1.81854 7.21422 -1.70755 +8374 4 29.1888 23.4521 8.90141 0.206013 -3.23773 -0.0922606 +8375 4 29.4815 24.5976 7.98987 7.61073 -10.2969 -5.72522 +8376 6 0.801466 7.54671 27.8401 6.5354 -3.49578 -14.7683 +8377 4 0.895859 7.27352 28.7573 1.78004 -0.979843 7.25552 +8378 4 1.54585 8.15528 27.6648 -11.1939 -10.5496 5.25649 +8379 6 15.4336 9.77253 0.489553 0.922542 4.3707 -1.35473 +8380 4 16.0351 9.34865 41.7726 4.14277 -6.55565 2.56274 +8381 4 15.4857 9.31476 1.34042 4.74784 -1.15717 -0.337147 +8382 6 18.8008 0.0730809 34.105 -10.3773 -6.96418 -21.8764 +8383 4 18.5081 41.5423 33.2731 5.22569 12.9238 15.5106 +8384 4 18.5071 0.998566 34.0742 -2.68781 1.40869 -5.2752 +8385 6 18.7326 30.7673 29.1559 48.9948 -22.8293 28.8452 +8386 4 19.5421 30.7479 29.7792 -35.6741 -9.01286 -31.0748 +8387 4 18.496 31.6741 29.187 -17.0068 24.787 -0.45657 +8388 6 48.459 16.4997 36.139 1.45519 10.5028 1.01521 +8389 4 47.6111 16.9857 36.2164 10.4415 -5.87096 -2.55811 +8390 4 48.4968 16.1176 35.2432 -2.18798 4.21486 5.30298 +8391 6 43.8007 0.467658 29.2569 28.3678 -13.8677 -3.77703 +8392 4 42.8971 0.305725 29.4937 -25.3214 -1.14832 5.94808 +8393 4 44.2622 41.5592 29.5347 -3.4854 12.8866 -0.12306 +8394 6 16.7282 13.8764 21.3804 -5.85841 5.25102 8.86173 +8395 4 16.2274 14.7005 21.5266 6.94274 -6.60805 -7.01164 +8396 4 16.607 13.4327 22.2267 1.29648 -4.09529 1.45702 +8397 6 17.3848 13.434 26.2514 27.8708 0.579352 -19.8612 +8398 4 18.2073 13.6243 25.7048 -28.5107 -7.2193 21.7409 +8399 4 17.5944 12.6077 26.718 -2.1357 3.12496 0.608863 +8400 6 48.1647 10.2208 23.7049 7.80266 -18.7522 13.388 +8401 4 47.9825 10.5204 24.6118 -3.05612 1.76991 -8.97221 +8402 4 48.0139 10.9468 23.1026 -1.19683 7.34816 1.26356 +8403 6 28.2773 17.9142 17.8758 3.72989 18.9709 -15.182 +8404 4 29.0682 18.432 17.6259 -4.1904 -8.84834 4.2635 +8405 4 28.5441 17.0749 18.25 8.7895 -11.8779 5.35139 +8406 6 54.0848 38.1774 23.6862 8.79068 2.20397 4.23058 +8407 4 0.0366427 38.003 23.4974 -14.1536 0.885634 -1.20583 +8408 4 53.5245 37.5494 23.203 6.54807 -0.952262 -0.611804 +8409 6 8.48984 18.3998 11.4055 -13.462 -3.57414 27.789 +8410 4 7.65602 18.6961 11.043 -9.38292 3.75479 -0.915161 +8411 4 9.09748 18.5243 10.712 30.3826 3.02886 -30.4498 +8412 6 45.9441 12.8818 11.0222 -16.4049 1.91652 -6.40765 +8413 4 46.711 12.6299 10.4835 -7.54952 -0.564906 -6.57768 +8414 4 45.1235 12.7466 10.4771 21.7466 0.735613 7.10643 +8415 6 16.2215 8.79448 14.033 27.9098 -14.9816 6.01142 +8416 4 15.5522 9.3752 13.7952 -53.829 20.9905 -11.5495 +8417 4 16.9359 9.40542 13.9326 31.9466 3.3348 3.59486 +8418 6 42.7223 13.3863 21.3918 29.8224 16.7773 6.64199 +8419 4 41.9142 12.8874 21.2836 -9.67718 -3.29752 -8.9243 +8420 4 42.6271 14.312 21.0975 -16.0363 -11.184 0.152454 +8421 6 20.9977 40.4228 16.4707 19.2311 -21.9074 5.84064 +8422 4 20.7341 40.0536 17.3362 -0.495629 5.04161 -8.05599 +8423 4 21.8212 39.937 16.2081 -24.2166 11.8961 5.45251 +8424 6 45.6397 11.4296 32.9439 38.4109 -29.1814 -9.99274 +8425 4 46.3321 10.7493 33.2028 -28.4056 24.9384 -5.22126 +8426 4 45.113 11.6624 33.7013 -7.79747 1.97566 18.4384 +8427 6 26.9602 8.8599 24.2968 13.5915 2.79356 4.8338 +8428 4 27.3951 9.75608 24.2837 -6.20264 -27.5971 5.81865 +8429 4 27.4821 8.2415 24.8764 -5.62896 20.549 -11.158 +8430 6 18.9707 2.44141 29.3655 -2.01209 17.0873 0.653095 +8431 4 18.2519 2.38593 30.0124 -1.45633 -1.83702 1.76482 +8432 4 19.0982 3.39915 29.1871 -0.208097 -9.69202 4.76181 +8433 6 8.2396 29.1642 19.724 -7.67611 -9.48635 17.3168 +8434 4 8.16332 28.9052 20.6672 2.00381 4.74558 -18.2193 +8435 4 7.79264 28.4685 19.2154 1.97612 2.42161 3.19163 +8436 6 9.03293 34.3085 18.6392 -6.8245 -3.51508 -5.57673 +8437 4 8.73043 34.3576 19.5508 2.61936 3.47829 -5.40237 +8438 4 9.19173 35.2194 18.3614 3.83285 -0.179546 -0.301582 +8439 6 10.1806 11.9309 11.2378 5.33181 -8.21116 5.18339 +8440 4 10.4199 12.8404 10.9987 -8.38943 -3.43734 -3.26379 +8441 4 9.2213 11.8063 11.1618 4.16708 15.3888 -2.40164 +8442 6 35.7388 21.6853 36.1571 -21.2187 21.2566 3.59668 +8443 4 35.0074 22.3505 36.1843 15.9506 -16.0405 0.715421 +8444 4 36.3839 21.978 36.8321 -7.05156 -5.2756 -8.86951 +8445 6 17.0774 12.5078 36.39 -5.14261 15.8003 12.7424 +8446 4 17.3404 12.7479 37.2961 -4.35419 -1.09545 -7.6232 +8447 4 17.4977 11.6659 36.234 4.71638 -15.3379 -7.50181 +8448 6 37.1607 13.034 34.2837 0.889917 6.85814 -56.1323 +8449 4 36.6144 12.2451 34.135 3.16712 2.80772 8.73621 +8450 4 37.2953 13.1592 35.1962 -1.91867 -3.10361 40.6259 +8451 6 38.9747 29.5563 13.2253 1.18838 24.1885 -12.4362 +8452 4 38.8174 28.6959 12.8484 -2.87796 -16.626 0.178868 +8453 4 38.7606 29.548 14.1582 -0.666122 -3.30753 9.89159 +8454 6 0.17037 29.343 29.4884 -1.26324 3.91124 -27.2421 +8455 4 0.785297 28.6867 29.1327 1.78511 -2.78426 6.40223 +8456 4 54.9717 29.8735 28.6813 -2.47422 -4.8209 18.3172 +8457 6 15.9286 0.264913 12.7638 2.77369 8.97324 -0.606717 +8458 4 15.3998 0.564835 11.9867 -4.35739 -9.72902 15.1241 +8459 4 15.3918 41.7399 13.4663 -4.26125 7.58409 -15.055 +8460 6 3.98508 11.9472 8.79546 -10.0423 -23.9471 10.8905 +8461 4 4.30821 11.7435 7.92681 6.40121 -7.70989 -16.6116 +8462 4 3.96465 12.8834 8.77069 -2.75643 37.1798 9.03734 +8463 6 24.0517 23.6768 19.9772 9.9875 -0.396554 0.578582 +8464 4 23.5025 22.9354 19.7663 -8.47693 -16.0962 -5.40355 +8465 4 23.4442 24.2751 20.4024 2.14545 13.6845 6.88162 +8466 6 4.48152 2.30986 23.9923 -27.0109 23.4084 27.373 +8467 4 4.59263 2.40669 23.0716 9.73085 -3.6317 -36.525 +8468 4 3.6479 2.81506 24.1139 10.3345 -10.6947 10.8816 +8469 6 33.0856 27.6588 33.8383 -8.68317 -6.77689 0.893276 +8470 4 33.3543 28.5605 33.6822 -2.66039 14.7626 -6.22211 +8471 4 33.7694 27.2718 34.3804 4.93538 -5.90298 8.33006 +8472 6 11.4012 21.7076 6.08442 -20.9181 -7.28975 6.20623 +8473 4 12.3452 21.6439 6.06884 23.6791 -0.506282 -5.12853 +8474 4 11.1369 22.1078 5.25059 3.06155 -0.534748 -3.52863 +8475 6 37.2275 13.5312 23.6107 -13.7454 14.8127 9.96245 +8476 4 37.2011 14.0176 24.4689 -4.04457 -8.03454 -15.7104 +8477 4 38.0738 13.1109 23.5305 19.2281 -7.80113 -1.86698 +8478 6 5.00929 21.0475 33.3676 1.03993 27.0325 -33.9401 +8479 4 4.24931 21.2691 32.771 13.0002 -8.94008 10.7478 +8480 4 4.70945 20.492 34.0664 -10.4226 -16.4153 18.9759 +8481 6 18.2024 37.5737 26.9347 11.0126 -1.54132 -8.69207 +8482 4 17.8515 38.4557 27.1129 2.92195 -1.85995 -3.39903 +8483 4 18.9058 37.6892 26.2602 -8.80934 -3.84756 9.96821 +8484 6 19.7475 16.1502 4.67922 -0.59461 -5.69737 6.80756 +8485 4 18.938 15.9829 5.17999 -0.503733 6.42822 -3.53139 +8486 4 20.452 15.899 5.29485 1.51569 2.54074 -3.7554 +8487 6 54.0588 32.502 15.5791 2.11509 -30.3723 -27.0265 +8488 4 54.9193 32.2734 15.944 -2.03587 2.87368 2.60187 +8489 4 53.7148 33.1889 16.1175 -9.21817 24.1266 16.9863 +8490 6 31.1319 3.81908 36.7331 -8.52453 -12.3767 5.98224 +8491 4 31.0251 4.01663 37.6709 2.24281 6.85123 1.97341 +8492 4 30.7371 2.93942 36.6325 4.48759 4.53933 -4.77061 +8493 6 11.8397 14.3559 5.95013 17.712 13.5011 32.6048 +8494 4 11.8882 13.4483 5.64785 3.21485 -4.29204 1.16864 +8495 4 12.4103 14.428 6.79608 -23.3682 -9.2254 -38.5841 +8496 6 30.4732 33.6903 6.46877 -20.5926 30.9984 10.0988 +8497 4 30.0823 33.146 7.15741 -0.571027 -8.82817 5.88036 +8498 4 31.0368 33.1406 5.95739 18.3645 -25.6031 -16.3825 +8499 6 12.7874 0.539502 21.6719 -8.5062 -5.44338 -19.1545 +8500 4 12.0427 0.939271 21.1459 16.6961 -1.79193 22.1421 +8501 4 12.8959 0.982969 22.5241 -5.23507 7.86641 1.50036 +8502 6 52.7588 7.2218 26.198 16.8025 28.3515 6.33153 +8503 4 53.4065 7.96379 26.3423 -21.978 -17.2249 -4.05545 +8504 4 53.0631 6.80021 25.3976 -2.37526 -6.61619 -6.13258 +8505 6 39.7335 40.8867 3.73325 7.25622 8.93714 -16.4459 +8506 4 39.3445 40.0379 3.8542 -7.03998 -23.1188 -2.87281 +8507 4 39.6833 41.2661 4.59764 3.93702 15.0893 17.324 +8508 6 20.121 31.9222 21.9838 -6.71526 -6.20654 6.86321 +8509 4 19.4522 31.9772 22.708 13.7594 -4.46219 -12.9776 +8510 4 20.3423 32.8279 21.7497 1.41177 8.86705 -0.575134 +8511 6 12.8675 35.0031 4.45346 44.828 -17.7313 4.60062 +8512 4 12.2237 35.6716 4.40701 -39.658 29.9319 -2.18346 +8513 4 13.7076 35.4677 4.24983 -7.53722 -6.26381 -0.0905995 +8514 6 24.0625 33.6591 24.8433 7.47563 8.71661 -6.22666 +8515 4 23.7256 32.9086 24.3593 -5.011 -9.84395 -6.229 +8516 4 24.8651 33.8891 24.3525 -1.08488 0.504411 0.449776 +8517 6 40.1566 40.8925 22.745 3.65995 -18.1772 23.084 +8518 4 39.459 41.1173 22.1514 -10.4135 8.7075 -19.9273 +8519 4 39.655 40.5713 23.5068 11.7186 -0.819555 2.88668 +8520 6 15.5608 2.83174 38.4548 -17.961 4.93292 18.3513 +8521 4 14.8017 3.44348 38.6509 23.1729 -8.01231 -13.692 +8522 4 16.317 3.27039 38.0376 1.48109 9.53369 -0.90723 +8523 6 41.0116 9.17543 16.9495 15.4695 -4.08523 -13.4682 +8524 4 41.9148 8.77619 16.8957 -14.8555 5.86712 4.74383 +8525 4 40.5932 8.80873 17.73 -3.00249 -3.47282 8.63794 +8526 6 43.1871 41.3934 9.57744 -8.69666 -18.4537 3.1119 +8527 4 42.3844 40.9156 9.26306 10.8189 9.37287 1.53096 +8528 4 43.2581 0.273962 9.04681 -5.03874 9.79533 -5.6553 +8529 6 24.9044 37.9223 30.7828 -39.5154 -3.84946 22.9815 +8530 4 23.9949 37.8093 31.2426 42.0603 4.56965 -20.1335 +8531 4 24.7148 38.3736 29.9542 -2.24489 2.04808 -5.58176 +8532 6 2.22015 5.33054 16.4399 10.309 -8.52293 4.98471 +8533 4 1.84892 4.56193 16.8809 -9.36945 -1.25887 4.31387 +8534 4 3.13742 5.05729 16.2666 0.349453 6.20437 -4.74718 +8535 6 1.39717 14.946 19.1428 25.1228 15.6369 3.14315 +8536 4 0.624759 14.5201 18.7755 -11.3456 -6.79531 3.66607 +8537 4 1.29195 14.9418 20.1112 -7.64559 -2.97115 -5.19376 +8538 6 34.323 26.551 23.7054 -6.89575 15.1076 -7.90432 +8539 4 33.5377 26.6273 23.1515 0.482254 10.7241 -2.26295 +8540 4 34.2298 25.6735 24.0419 5.3831 -21.6418 13.1607 +8541 6 41.9187 21.8289 37.5387 -12.5221 18.6557 -0.654717 +8542 4 42.0641 21.2774 38.3263 -4.73604 7.9145 -4.0056 +8543 4 41.3184 22.5612 37.831 11.9642 -17.2916 1.51119 +8544 6 39.4187 37.6728 12.6286 4.8532 5.57593 -2.65087 +8545 4 38.7905 38.0203 13.2933 13.4683 3.10916 -9.30227 +8546 4 40.0129 38.4033 12.3216 -17.7433 -13.1833 12.1033 +8547 6 30.24 35.8848 2.88572 49.7685 -5.59713 18.4489 +8548 4 29.7974 35.0543 2.80033 -9.93294 -19.906 -6.06696 +8549 4 29.6668 36.5692 2.63166 -32.6151 32.1739 -11.9765 +8550 6 50.3574 12.2906 11.0327 -10.5999 -17.0186 -10.0309 +8551 4 50.5337 13.0768 11.5186 9.60091 28.0994 7.49192 +8552 4 50.105 11.6994 11.7365 -4.43527 -18.2768 5.14926 +8553 6 38.4177 1.51331 34.6454 7.78381 -17.0522 33.0946 +8554 4 38.2699 2.04814 33.8899 -7.54861 16.9144 -29.9652 +8555 4 38.0471 0.642488 34.4678 -6.5188 -5.83242 -9.72252 +8556 6 23.4539 32.2409 29.2188 -19.2438 22.9381 45.5983 +8557 4 24.0079 32.8299 28.7229 8.54827 0.527122 -15.0299 +8558 4 23.2413 32.797 30.0413 4.80705 -31.5817 -31.7916 +8559 6 36.5701 38.8746 8.90535 32.3223 -9.33237 29.2552 +8560 4 35.9325 39.4424 8.49935 -20.4423 23.0824 -8.61697 +8561 4 36.7801 39.1579 9.82993 -12.7327 0.605838 -19.3651 +8562 6 35.8737 15.8498 32.4386 8.92141 19.9053 -4.5399 +8563 4 36.1418 15.4504 33.2665 1.19933 -3.86396 7.25653 +8564 4 36.5179 16.5897 32.2945 -14.9335 -15.4114 1.1633 +8565 6 22.2892 21.8291 41.5841 -16.2626 10.7882 17.5339 +8566 4 22.1223 22.8053 41.6744 16.5914 -23.4811 -7.73209 +8567 4 23.1242 21.6534 41.1409 10.4107 9.35007 -4.50107 +8568 6 24.3606 38.6964 37.0146 17.4204 12.5043 -4.63866 +8569 4 25.2779 39.064 36.9978 -17.1771 -5.52971 -1.04157 +8570 4 24.4186 37.9719 37.6407 -4.78215 -9.12154 5.30794 +8571 6 45.8441 22.068 16.038 0.340293 -0.250982 -17.8101 +8572 4 46.1771 22.3609 15.1533 -8.50833 -8.1377 19.1007 +8573 4 45.4344 21.1785 15.9468 10.2139 13.0315 -4.03882 +8574 6 34.0918 26.1359 39.6112 38.0511 -8.91464 13.1738 +8575 4 33.1848 26.2338 39.3827 -25.4265 4.60567 1.8853 +8576 4 34.221 26.2032 40.5833 -12.0295 -1.62025 -11.2558 +8577 6 7.22533 36.1661 23.281 -59.3132 -5.14125 -34.652 +8578 4 7.26364 37.0581 22.9295 6.20379 9.34593 -2.3157 +8579 4 7.97006 36.0735 23.8015 59.451 -4.11437 40.0555 +8580 6 29.1637 40.7448 9.14206 -2.51826 7.72751 -13.9009 +8581 4 29.0444 40.3656 8.22324 15.9504 -2.90487 33.8878 +8582 4 29.7314 40.248 9.77766 -4.36215 -9.31282 -20.9127 +8583 6 29.3678 11.2357 1.30083 -35.1077 14.24 19.1284 +8584 4 28.4669 11.4731 0.940057 29.2946 -5.02339 11.2991 +8585 4 29.318 11.4379 2.27092 4.83193 -7.95866 -28.0539 +8586 6 30.9732 3.71267 14.0776 15.2348 -46.8383 -31.5788 +8587 4 31.4582 2.88428 14.3733 -12.5046 34.6753 7.46482 +8588 4 30.8397 3.49874 13.1133 -3.67459 15.4991 23.3176 +8589 6 29.7056 15.2804 38.2794 -11.9618 14.5562 -33.6413 +8590 4 30.2702 15.1354 39.0168 20.1567 -4.59268 23.419 +8591 4 30.0841 16.0123 37.7308 -6.59039 -15.0688 15.6005 +8592 6 36.6264 0.310111 29.1514 -5.04796 -7.83703 -2.09784 +8593 4 37.4271 0.819379 29.3706 -8.93441 4.46737 -4.0897 +8594 4 35.9914 0.856083 28.6484 15.2391 -5.29618 7.37908 +8595 6 47.6417 0.116275 23.248 13.5287 8.94531 -12.2883 +8596 4 47.0119 0.433387 23.8864 -15.3927 3.59754 12.8324 +8597 4 47.4641 41.0946 23.1357 -2.49679 -12.2922 2.24912 +8598 6 7.90637 37.1762 29.9388 8.54368 22.8184 26.8453 +8599 4 7.85301 37.2098 30.9449 3.45275 -3.37357 -41.2712 +8600 4 8.44496 37.9737 29.6897 -17.0006 -23.7003 10.0801 +8601 6 38.9296 24.2329 12.6383 15.5219 -16.6974 -22.776 +8602 4 37.9787 24.1601 12.7323 -9.9748 0.376678 1.49713 +8603 4 39.1449 23.5705 11.9215 -5.67631 22.059 20.3409 +8604 6 21.3179 26.2613 36.7933 11.7928 19.07 -1.51604 +8605 4 20.8397 25.6962 36.2015 -9.60619 -6.53459 -13.3894 +8606 4 21.5182 25.6957 37.5187 2.0605 -10.1459 21.1123 +8607 6 28.2262 23.3351 24.9913 6.08955 -0.748437 0.460504 +8608 4 28.2308 24.0016 25.6964 4.22655 -6.81745 -1.24962 +8609 4 29.0479 22.8075 25.0363 -13.73 7.51762 2.95505 +8610 6 38.3897 39.5713 14.5774 34.0997 -9.77678 18.0089 +8611 4 38.4779 38.8655 15.2987 -6.58584 29.8461 -29.0755 +8612 4 39.3026 40.0121 14.5422 -41.1029 -19.3921 -1.23505 +8613 6 26.0587 6.01626 38.1331 -7.56489 -16.2073 9.45163 +8614 4 26.364 6.92283 38.0032 14.5247 -0.467326 2.92393 +8615 4 26.7573 5.38712 38.4414 -3.391 26.9876 -7.34507 +8616 6 52.1178 17.2513 22.5128 -10.8492 5.54118 7.42996 +8617 4 52.8997 17.6733 22.1718 9.92427 15.7211 -4.0445 +8618 4 52.2219 16.3395 22.2718 -2.102 -18.0313 -4.16051 +8619 6 39.531 30.2011 31.4754 1.32431 5.33104 20.3977 +8620 4 40.1389 30.6029 32.1578 -26.1612 -12.9519 -10.6425 +8621 4 38.6407 29.9778 31.8528 28.462 12.4065 1.81878 +8622 6 19.6595 6.91666 12.7659 -14.5008 4.80913 14.0157 +8623 4 19.6887 6.47111 13.6446 7.23462 -2.42447 -18.0556 +8624 4 20.266 6.55226 12.115 5.2883 -10.9354 6.21868 +8625 6 32.4266 37.4954 40.1172 13.7501 31.88 -47.4625 +8626 4 32.7425 36.6266 39.9032 -2.48661 -20.9779 5.59445 +8627 4 32.1419 37.5817 40.9958 -11.8933 -10.3197 48.8363 +8628 6 39.7596 0.337115 6.09995 15.1421 -1.66777 24.2876 +8629 4 40.1534 1.22219 6.08152 -5.11901 -0.972083 -7.53812 +8630 4 40.1657 41.8549 6.90018 -9.37436 -2.20237 -11.3555 +8631 6 28.7751 10.1584 29.138 -2.01192 2.80513 -2.93319 +8632 4 27.8238 10.1744 29.001 -3.57801 1.81269 -4.50746 +8633 4 28.8919 9.80572 30.0274 6.34341 -2.0407 -1.56061 +8634 6 28.3442 21.074 10.6333 2.67716 -1.32955 -8.08167 +8635 4 28.7162 21.9756 10.7458 1.68682 -14.6392 -2.70928 +8636 4 28.9848 20.5267 10.1317 -8.30024 16.2649 10.4277 +8637 6 27.0693 28.6863 20.8775 28.7719 -2.37794 4.3254 +8638 4 27.7298 29.2434 21.3283 -4.93173 -3.86203 -1.8773 +8639 4 26.2334 28.9344 21.2444 -24.6691 6.36732 10.1211 +8640 6 39.6873 13.9804 33.4544 10.1398 -5.61125 10.7915 +8641 4 40.0465 13.7022 34.3167 -4.86 2.4669 -10.6871 +8642 4 38.7726 13.6755 33.4723 -5.1401 -2.85022 0.606476 +8643 6 25.4597 11.6576 34.3181 14.491 -28.0098 33.8508 +8644 4 24.8514 11.0162 34.7619 5.36553 12.2612 -15.2396 +8645 4 25.0161 12.1454 33.6493 -21.152 12.7672 -16.4478 +8646 6 27.5131 37.6326 21.427 -19.9573 -21.9997 -23.7283 +8647 4 28.2253 37.2064 20.96 8.67225 -9.05343 -17.242 +8648 4 27.9596 38.068 22.1137 20.557 20.5047 35.0331 +8649 6 30.5914 20.0695 28.6348 27.7431 -17.6396 19.2377 +8650 4 30.9836 19.3645 29.1801 11.8534 20.0629 -12.5158 +8651 4 29.6982 19.8076 28.6872 -39.6618 5.20089 -10.7407 +8652 6 42.3778 1.85684 14.9393 25.4983 -1.50621 30.9456 +8653 4 41.9471 2.41032 15.6124 -5.43016 1.03086 -4.74891 +8654 4 41.8361 1.80616 14.1675 -19.8596 2.00334 -17.6468 +8655 6 12.1616 12.5321 19.523 -14.5305 -6.69845 -4.01711 +8656 4 12.9939 12.0448 19.446 -0.641831 -5.10207 -0.17564 +8657 4 11.4028 11.9007 19.4323 17.6183 8.93718 0.635936 +8658 6 19.2173 1.21358 16.3673 12.2327 1.89672 9.92834 +8659 4 19.755 0.600796 16.911 -5.77615 9.45405 -9.5745 +8660 4 19.8129 1.9499 16.1364 -2.75311 -6.47505 -0.557351 +8661 6 9.48027 16.145 27.6887 18.4383 23.7652 -21.1678 +8662 4 9.95062 16.009 26.8224 -12.6846 -2.19341 25.2173 +8663 4 9.19893 15.3052 28.0262 -3.30777 -17.5687 0.945009 +8664 6 40.4566 26.1709 24.7821 -20.4805 41.2174 -0.532491 +8665 4 40.3628 26.7039 25.5991 10.1463 -19.7663 1.05084 +8666 4 40.0809 26.8306 24.1463 10.2053 -25.1837 1.88999 +8667 6 47.6675 17.6506 18.0225 -30.0634 41.3074 12.2788 +8668 4 48.2543 17.9981 18.7254 0.401995 -10.3127 -9.33209 +8669 4 46.9068 18.3177 18.0388 29.0716 -28.5939 -1.2112 +8670 6 36.6158 25.2629 4.18774 29.3736 28.0527 4.32129 +8671 4 36.5214 25.5758 5.09839 -16.0305 -5.04511 0.138651 +8672 4 37.2819 25.9232 3.86538 -16.6324 -17.2389 -6.3952 +8673 6 39.5728 35.3879 29.6636 12.278 22.7044 -7.26925 +8674 4 39.0499 34.5938 29.661 -5.91236 -8.06683 2.48368 +8675 4 39.3907 35.9006 30.4607 -1.7908 -9.53931 -1.38728 +8676 6 0.412001 14.6096 13.3342 2.26376 -2.5079 -14.7045 +8677 4 54.7802 15.2759 13.6175 -3.32355 6.27336 -0.974202 +8678 4 0.516441 14.0579 14.0961 4.60085 -12.9246 15.0473 +8679 6 12.196 27.3305 8.43326 10.0473 13.6833 14.0535 +8680 4 13.031 26.8669 8.51701 2.31971 -16.5604 -6.51009 +8681 4 12.4357 28.1833 8.85089 -17.0888 -3.60228 -10.1051 +8682 6 36.9057 14.8161 21.1198 30.6025 20.2317 -25.7914 +8683 4 37.0125 14.4244 21.9807 1.92342 -10.2074 20.832 +8684 4 37.7936 15.2053 20.874 -24.9082 -16.5351 5.08732 +8685 6 20.8486 4.94275 21.105 17.9022 -6.61396 -0.309651 +8686 4 20.374 5.67415 21.5228 9.17185 2.06744 3.08402 +8687 4 21.7751 4.88103 21.448 -24.8745 1.45604 -2.42669 +8688 6 36.7441 1.80601 7.63303 -8.86792 14.8212 -18.8361 +8689 4 36.3577 2.71345 7.77493 14.0998 -30.8697 16.0099 +8690 4 36.9898 1.34966 8.45182 -6.21638 14.7491 3.51078 +8691 6 12.2291 31.5076 37.4606 -20.8205 4.71929 16.9336 +8692 4 12.7789 31.2189 36.7301 -1.71439 -5.19212 -6.77065 +8693 4 11.3837 31.0118 37.4916 13.4088 3.21935 -3.86138 +8694 6 38.9875 41.6041 16.8806 -4.97036 -4.86794 -9.64455 +8695 4 39.4307 41.5716 16.0177 3.10466 0.790549 7.7281 +8696 4 39.367 0.410173 17.3903 6.57234 9.13046 2.45051 +8697 6 31.8971 27.2651 22.2536 0.475946 9.95506 -26.8482 +8698 4 31.2288 26.6192 22.5148 1.53167 3.01995 -0.700727 +8699 4 31.6701 27.5469 21.3168 1.33988 -13.0026 32.8364 +8700 6 42.7373 9.18402 25.5752 -16.5205 -8.12573 12.5156 +8701 4 42.0715 8.82875 24.9549 8.97347 3.93682 -3.18445 +8702 4 43.4726 9.55718 25.0966 9.17117 4.66181 -14.1392 +8703 6 50.9317 28.1762 25.3585 1.81467 11.9603 16.0249 +8704 4 50.4332 27.6858 24.699 -7.797 -4.30978 2.61883 +8705 4 50.6061 27.9816 26.259 1.82058 -3.16123 -16.2825 +8706 6 43.2019 19.6758 30.9261 -60.5069 12.608 18.1565 +8707 4 44.1121 19.7947 30.8273 58.227 11.7487 -4.80009 +8708 4 42.8317 20.4979 31.3452 14.2318 -14.5845 -6.94071 +8709 6 30.6579 14.0392 40.8099 -3.90856 28.8453 32.4485 +8710 4 30.2625 14.437 41.6588 6.78025 -22.1962 -33.7862 +8711 4 30.2388 13.192 40.6401 -8.31431 -9.09038 5.19898 +8712 6 20.9126 15.487 23.0255 1.81996 -1.2716 -0.577536 +8713 4 20.3529 16.1851 23.4151 9.86352 -5.06847 -1.26552 +8714 4 21.845 15.6804 23.2451 -11.0139 0.781722 1.09061 +8715 6 34.2266 0.759926 35.8266 5.91607 -35.831 36.3238 +8716 4 34.6699 1.4486 36.3596 -6.19332 -9.6922 -6.67054 +8717 4 34.0788 41.8551 36.4474 5.42693 41.8664 -30.5853 +8718 6 38.9146 36.9114 35.918 21.2173 -10.8751 17.2864 +8719 4 39.7829 37.095 36.338 -12.434 5.66027 -11.9648 +8720 4 38.7157 36.033 36.27 -5.46808 2.11761 -7.10044 +8721 6 45.1412 25.209 22.7799 -9.21588 11.7282 35.1943 +8722 4 44.1635 25.1535 22.9277 18.3683 -4.67801 -8.38153 +8723 4 45.395 24.8019 21.9606 -9.08047 -9.94082 -17.9945 +8724 6 40.6079 0.819632 35.9543 -10.1658 30.0784 -5.29357 +8725 4 40.5743 41.7978 35.9297 8.39322 -37.6139 4.80851 +8726 4 39.8853 1.04128 35.3423 10.5918 6.58535 9.58714 +8727 6 11.0481 28.354 35.0263 -7.05837 2.15472 6.15391 +8728 4 11.0065 27.7661 35.7937 6.20016 -1.50115 -1.31869 +8729 4 10.2774 28.923 35.1598 -2.00076 2.29074 -4.05614 +8730 6 20.214 13.5993 35.8619 28.0429 -16.4719 23.5579 +8731 4 19.4963 13.9327 35.3857 -45.1468 12.1599 -23.9045 +8732 4 20.9404 14.0304 35.4284 21.7873 4.64258 -6.99651 +8733 6 39.6259 5.13927 1.77541 6.3837 10.5905 23.0009 +8734 4 38.815 4.76887 1.43754 -8.89155 -4.8304 -7.9643 +8735 4 40.2998 5.10051 1.09544 5.70124 1.55861 -13.0764 +8736 6 30.2644 30.8765 32.4376 2.45351 13.5189 11.7538 +8737 4 29.6638 31.1848 33.1457 1.37952 -7.29152 -6.97913 +8738 4 29.9065 30.0722 32.0512 -6.5155 -7.29863 -0.0927806 +8739 6 14.5561 10.991 22.8667 10.081 16.7623 43.7388 +8740 4 15.1677 11.6459 23.3133 -13.9792 -18.4015 -26.7579 +8741 4 13.9431 10.829 23.6181 3.59137 -7.6484 -17.8174 +8742 6 20.7554 13.9367 3.0184 -22.7431 -13.2276 -14.851 +8743 4 19.9027 13.7405 2.57467 24.082 -4.954 3.77469 +8744 4 20.4786 14.7044 3.49738 5.42185 19.6619 18.2233 +8745 6 41.2999 4.28373 12.6115 -5.11846 11.2121 16.06 +8746 4 40.5902 3.66826 12.7964 -5.45414 -3.74116 2.1628 +8747 4 41.646 4.04628 11.766 6.8814 -9.70345 -22.8074 +8748 6 10.8486 24.7151 21.7079 -22.0181 20.7635 -2.99902 +8749 4 10.06 25.055 21.1824 26.1755 -20.3138 8.68391 +8750 4 11.196 23.8735 21.3742 -8.74412 -0.217035 -8.2032 +8751 6 53.5851 20.8962 34.3615 -20.5776 4.99959 -7.54911 +8752 4 54.5312 20.9399 34.3174 23.7346 3.60458 -0.717784 +8753 4 53.3344 20.0378 34.731 7.46747 5.54606 -4.26157 +8754 6 14.8822 4.84805 30.4483 -9.71325 -6.00753 -19.6684 +8755 4 14.771 4.94284 29.4789 1.77408 0.90497 14.7496 +8756 4 14.5561 3.94513 30.5986 4.49673 6.24836 5.5759 +8757 6 48.9024 37.1196 13.1149 -36.5603 24.8322 -14.1851 +8758 4 47.9606 37.2057 13.4129 22.1922 -3.12109 -3.19476 +8759 4 49.2987 36.4589 13.6532 13.3268 -16.5999 12.901 +8760 6 26.8059 19.3169 7.54434 -4.26945 -4.42367 7.83904 +8761 4 27.1766 18.4867 7.22339 -3.92405 -4.32352 -1.07463 +8762 4 27.3968 19.9842 7.20607 8.782 12.6164 -5.40832 +8763 6 17.6305 11.9358 39.0864 -20.6439 9.19078 16.9487 +8764 4 18.5077 11.609 39.0209 28.8526 -12.5757 -8.06323 +8765 4 17.5232 12.1203 40.0373 -6.81014 1.23205 -8.73836 +8766 6 49.927 14.591 8.61416 15.5742 -26.1486 -8.96269 +8767 4 49.2009 13.9524 8.72368 2.87529 10.9098 3.94828 +8768 4 49.6414 15.4659 8.85563 -10.1676 20.5637 7.32703 +8769 6 32.3582 34.9735 31.5167 -0.414276 11.4895 24.1707 +8770 4 32.1283 34.3825 30.8126 -1.81559 -4.89127 -12.898 +8771 4 32.4479 35.8663 31.1601 -0.97656 -3.19104 -3.1743 +8772 6 11.821 22.2226 21.3194 1.12988 -20.2292 -31.7924 +8773 4 12.2035 21.6949 20.5593 -17.646 16.3031 19.3587 +8774 4 12.5076 22.1609 21.967 14.4856 1.86701 17.8995 +8775 6 33.8479 9.95925 13.6297 5.85555 4.94861 0.641841 +8776 4 32.9412 9.60258 13.4965 20.4646 2.44791 -13.0803 +8777 4 34.46 9.81143 12.8638 -25.0852 -4.3509 9.75457 +8778 6 25.5216 36.3896 1.4985 -3.83916 -1.90754 -5.44184 +8779 4 26.1733 36.851 0.947779 -3.43756 3.58217 3.68691 +8780 4 24.6678 36.8514 1.38848 10.8858 -3.23471 -1.95008 +8781 6 26.2654 10.5456 9.75524 -44.5011 8.64206 25.1655 +8782 4 25.6084 11.269 9.60979 18.788 -4.56637 -6.88642 +8783 4 25.8198 10.0845 10.5139 21.0346 7.54764 -16.1236 +8784 6 25.0247 0.792222 40.9035 16.6629 9.7536 -9.8108 +8785 4 25.2766 0.410293 40.0414 -7.0744 -0.853038 7.71488 +8786 4 25.4535 1.67289 40.8914 -6.39875 -10.0211 5.33714 +8787 6 46.2514 3.92331 24.811 2.29787 -10.4124 3.565 +8788 4 46.4476 4.07649 23.8793 1.84574 -7.0337 -1.43198 +8789 4 46.0806 2.96577 24.928 -3.00701 8.9366 -8.52535 +8790 6 21.593 13.605 29.211 2.46069 1.87638 12.7155 +8791 4 21.5518 14.2847 29.9136 -0.977025 -6.07097 -8.18011 +8792 4 21.3035 14.062 28.4178 -1.02829 3.62716 -1.29843 +8793 6 36.772 38.3747 0.364057 -13.57 -14.6746 -5.92565 +8794 4 36.4241 39.1227 0.863015 -2.10343 5.30459 -0.282121 +8795 4 36.0255 37.7419 0.250491 13.2024 11.0478 3.68109 +8796 6 19.3024 17.6377 24.0664 34.4056 30.1631 -22.0465 +8797 4 18.4191 17.3498 24.1437 -40.9446 -15.7866 5.54764 +8798 4 19.2946 18.2748 23.3003 0.347271 -14.2409 17.5238 +8799 6 23.1729 12.6936 3.50527 -23.4203 -1.67393 -9.32385 +8800 4 22.2599 12.987 3.28408 10.1497 2.83055 6.60862 +8801 4 23.2366 11.8468 3.05081 2.04707 -0.882582 2.79058 +8802 6 37.8929 8.88926 35.4532 -15.1513 -19.5409 -35.7954 +8803 4 38.8496 8.85033 35.2802 -3.80753 -1.00094 -0.145651 +8804 4 37.4409 8.32345 34.738 24.7998 24.8105 28.8968 +8805 6 14.3214 15.124 36.1936 10.1777 -8.45579 -11.337 +8806 4 15.1189 15.6285 36.3983 0.383997 -0.909139 3.4786 +8807 4 13.728 15.2114 36.9249 -8.84751 6.7001 14.2991 +8808 6 35.0764 0.951221 33.027 4.39995 -0.747562 -23.3066 +8809 4 34.9707 1.92678 33.0471 -0.901583 -14.825 16.9845 +8810 4 34.929 0.489106 33.8671 -4.79444 18.9729 2.67887 +8811 6 50.9368 0.508345 17.9996 -16.1068 -2.11236 -10.8013 +8812 4 50.7363 1.3993 17.6607 6.59543 -7.82408 5.75367 +8813 4 50.2126 41.8571 17.6452 15.113 5.01242 7.08044 +8814 6 26.2276 30.5707 0.943679 2.98972 25.4521 29.679 +8815 4 26.9747 31.0717 1.30878 -11.5718 -5.07384 -0.177367 +8816 4 26.5685 30.1289 0.190254 7.28539 -15.5247 -23.6744 +8817 6 18.5631 38.2963 4.56281 15.0547 -0.00169581 -1.07608 +8818 4 17.6313 38.4808 4.44067 -9.04909 6.52025 -3.84653 +8819 4 19.0145 38.7079 3.79419 -7.75189 -5.39823 9.30868 +8820 6 31.1327 5.08368 4.10816 20.0095 -18.3558 -6.33253 +8821 4 31.8391 4.51927 4.54922 -26.0459 18.0586 -17.7145 +8822 4 31.2112 4.96997 3.12633 -1.20575 2.29654 19.098 +8823 6 26.4386 21.9021 1.48262 11.6176 -12.3641 -2.34526 +8824 4 26.4119 22.77 1.11333 -7.24657 26.8604 -8.21156 +8825 4 27.3591 21.6321 1.37052 -1.3799 -4.61827 0.12427 +8826 6 39.218 11.6975 22.8013 10.5737 17.0434 4.86912 +8827 4 39.8837 11.6898 23.5135 -8.12783 -9.21376 -3.17514 +8828 4 38.7576 10.8611 22.7762 -0.316566 -9.51531 5.7902 +8829 6 13.6104 36.3454 30.6448 12.2201 31.8005 15.4331 +8830 4 13.9411 37.0787 31.1944 -5.64032 -6.12374 -20.8561 +8831 4 13.4819 35.6769 31.3099 -5.82879 -19.5305 -1.97286 +8832 6 50.5737 9.8729 9.34449 -28.5439 -15.8542 -0.594603 +8833 4 49.6941 9.5296 9.68217 24.5077 10.0039 -8.16891 +8834 4 50.7802 10.6382 9.87905 1.56032 8.49656 8.37591 +8835 6 49.6568 40.2957 22.5808 3.13406 -4.17489 -1.45496 +8836 4 49.9643 39.4131 22.2832 -6.04563 10.523 5.74674 +8837 4 49.4657 40.2311 23.537 6.08697 -6.10842 -7.72776 +8838 6 7.19984 41.3227 28.8903 -1.52952 20.6044 28.9443 +8839 4 7.18166 41.5789 29.8666 2.82963 -8.74683 -37.3978 +8840 4 7.33954 0.237732 28.3754 1.09714 -11.2116 9.436 +8841 6 13.0357 18.018 25.3358 19.442 16.9905 44.3108 +8842 4 13.6166 18.1186 24.5548 -1.12298 4.17303 17.3747 +8843 4 13.5323 18.3306 26.2146 -21.9746 -20.4015 -59.5043 +8844 6 50.052 19.589 2.43093 38.9512 -4.48133 -22.8803 +8845 4 50.7424 19.2598 1.79532 -23.4729 1.49397 14.1456 +8846 4 50.5528 20.298 2.8491 -7.87613 8.00017 8.65361 +8847 6 28.349 40.9814 24.5177 14.9096 -9.01222 -0.77751 +8848 4 28.8235 40.5955 23.7606 -4.31864 4.07524 4.80921 +8849 4 27.7156 41.5877 24.1507 -14.6867 11.3415 -7.76415 +8850 6 19.4129 5.36023 29.5381 -15.1481 -17.3665 11.3948 +8851 4 20.1134 5.96028 29.2689 3.1753 8.4576 0.913483 +8852 4 18.7407 5.8353 30.064 8.44892 1.72514 -6.85652 +8853 6 35.3149 40.1584 22.2743 -5.4761 3.67764 -22.0922 +8854 4 35.6772 39.8166 23.0859 3.70556 0.822605 11.3301 +8855 4 35.3088 41.1243 22.2924 6.6179 -0.993945 11.5959 +8856 6 16.1846 33.7767 9.75922 -0.358556 8.53088 17.0233 +8857 4 15.9516 33.2005 9.03859 1.48669 -13.8429 -11.0903 +8858 4 15.6081 34.5411 9.70154 -4.21994 3.45608 -1.0308 +8859 6 17.3638 40.6569 20.2187 0.0478101 13.797 12.0053 +8860 4 17.2553 39.7868 20.6094 -1.96745 -8.64858 -4.42208 +8861 4 17.5346 41.2369 20.9867 0.609446 0.00823871 -10.958 +8862 6 20.5168 9.71855 9.57392 23.3053 8.23996 -15.5036 +8863 4 21.1612 10.0129 10.2371 -5.46071 -1.58749 -5.90152 +8864 4 19.8092 9.36498 10.0856 -20.4585 -11.5711 12.7624 +8865 6 47.4431 20.1927 21.3797 46.3705 -23.5901 12.8176 +8866 4 48.2534 19.5912 21.2825 -32.1103 24.8918 7.30718 +8867 4 46.9863 20.0806 20.5604 -17.463 -0.0836882 -22.1962 +8868 6 38.4119 40.7863 37.8131 4.58972 -16.3007 -8.86139 +8869 4 38.2015 41.716 37.7675 -2.07213 19.1933 -0.538509 +8870 4 38.1163 40.4897 38.6817 -2.89344 0.451293 5.51523 +8871 6 4.78246 1.95264 13.1142 -0.962758 -11.3299 -4.56483 +8872 4 4.86308 1.24617 12.4504 1.09441 11.0888 1.2667 +8873 4 4.58181 1.48453 13.9266 -0.88642 0.622503 9.15822 +8874 6 46.8366 29.0044 2.17213 -21.5573 10.7483 2.0879 +8875 4 46.5703 29.0979 3.11526 14.9241 -10.138 -17.8178 +8876 4 47.6533 28.5191 2.04264 7.39387 -6.09514 13.7966 +8877 6 37.4332 26.1628 25.6457 0.476866 -1.57884 -3.35254 +8878 4 37.1432 25.5044 26.2761 -1.46501 -6.7424 3.65975 +8879 4 36.6379 26.5951 25.3475 -3.92424 6.80267 -0.609098 +8880 6 27.3215 4.19863 19.437 6.03131 -5.89417 1.59018 +8881 4 28.0693 4.5088 18.8685 -19.6633 0.0824503 4.70742 +8882 4 26.4692 4.57526 19.1444 8.48727 3.90116 -6.43998 +8883 6 29.5816 35.1763 32.6702 11.3433 -15.1984 -13.0035 +8884 4 29.498 34.4257 32.0309 -0.34209 19.1564 15.9908 +8885 4 30.487 35.489 32.5363 -2.16348 -1.10322 -0.755163 +8886 6 51.6039 27.3804 34.6228 -16.2846 20.7721 3.47149 +8887 4 51.9118 26.5342 34.8842 8.46829 -31.6815 14.0056 +8888 4 52.043 27.5552 33.7939 4.07896 7.882 -12.2594 +8889 6 26.213 15.718 22.6983 4.45652 -13.2698 4.19624 +8890 4 25.9644 16.5706 22.3629 -2.74203 26.12 0.0562263 +8891 4 25.9462 15.1046 22.0171 -4.99078 -11.3651 -6.14484 +8892 6 36.1284 41.1872 15.4686 -15.9675 5.34592 -0.326298 +8893 4 35.5872 40.4009 15.2728 11.0637 0.363161 -0.898578 +8894 4 37.0593 40.962 15.4319 4.98109 -12.2962 -3.97184 +8895 6 18.4605 8.81439 11.2163 9.85092 25.9028 -2.05591 +8896 4 18.8222 8.21565 11.8732 -2.65799 -9.87079 3.83174 +8897 4 17.6938 8.4288 10.8111 -9.58752 -11.4871 -1.05984 +8898 6 30.2054 21.3176 23.2008 0.0321998 2.06754 0.100272 +8899 4 29.9991 22.2239 22.9456 -2.76699 -3.99559 -1.97847 +8900 4 29.5697 20.7243 22.7648 2.21136 7.68347 0.454199 +8901 6 22.7376 2.20942 34.8415 -7.06988 -25.8748 21.345 +8902 4 22.3263 1.32441 34.7915 6.81547 13.2405 5.99888 +8903 4 22.6443 2.51876 33.959 0.748808 17.6695 -28.972 +8904 6 12.6779 2.74229 12.3423 -3.02369 13.9186 -14.8572 +8905 4 12.6684 3.63953 11.9163 1.20981 -22.4864 12.4813 +8906 4 13.1874 2.20366 11.7175 -0.841633 0.53426 4.77071 +8907 6 24.0891 30.0714 14.5767 2.26717 -13.4561 -11.586 +8908 4 23.8674 30.8343 15.1637 -15.8173 -12.4528 -15.4046 +8909 4 23.3482 29.6562 14.0436 11.1594 27.3113 22.4963 +8910 6 0.0169515 27.9037 22.8558 -22.9231 2.02358 -4.19556 +8911 4 54.5653 28.3586 23.5905 7.88497 -1.22395 1.09473 +8912 4 54.2173 27.7016 22.3138 13.4725 -1.40758 1.11908 +8913 6 12.3768 4.48401 25.8984 -1.01368 1.72138 -1.86924 +8914 4 11.999 5.34556 25.8124 1.61778 23.022 -11.6285 +8915 4 11.6412 4.07623 26.3496 -0.520107 -24.5543 7.98643 +8916 6 50.6552 14.4595 5.90563 -9.7075 2.6569 37.2621 +8917 4 51.421 15.0215 5.71422 1.2699 0.536098 -2.53407 +8918 4 50.4862 14.5526 6.9139 5.60038 -4.97296 -46.1729 +8919 6 52.566 22.8545 20.1304 -1.0263 1.56712 -17.1158 +8920 4 52.8493 23.3468 20.8979 1.30497 -0.175929 17.7779 +8921 4 52.7622 23.494 19.4302 -3.4332 -7.01119 -2.14697 +8922 6 43.5747 16.5432 12.8706 26.1082 -6.15301 -20.1459 +8923 4 44.3581 16.1075 12.4177 -27.2623 16.7463 17.9516 +8924 4 42.8105 16.3628 12.3102 -5.85283 0.59737 -2.51971 +8925 6 15.9643 16.7491 40.5889 4.71604 31.6512 -1.38133 +8926 4 16.4157 17.2981 39.8953 -10.7397 -16.8436 16.4649 +8927 4 15.6568 17.4119 41.253 8.12177 -13.8769 -14.2686 +8928 6 23.4093 18.8548 23.8539 -16.419 -4.21219 2.12821 +8929 4 23.4427 19.3457 24.6888 0.296298 -1.81048 -2.30579 +8930 4 22.5005 18.9913 23.5305 9.65682 -2.29273 2.24785 +8931 6 46.4286 3.27372 31.8783 1.50761 -1.36157 -5.63512 +8932 4 45.559 3.26328 31.468 -2.27736 -0.687336 -10.0334 +8933 4 46.2409 3.35124 32.8099 7.04458 2.11131 4.36323 +8934 6 43.404 41.0501 12.2894 -4.74196 -21.563 6.60959 +8935 4 43.6943 41.7945 12.8025 5.82787 10.392 6.16968 +8936 4 43.4921 41.2918 11.3656 -0.276957 5.00436 -10.4807 +8937 6 7.4944 32.479 29.5886 4.16519 42.7458 -9.72808 +8938 4 8.11522 31.7905 29.7504 15.4265 -22.4366 1.70525 +8939 4 8.06583 33.2868 29.4339 -18.9062 -19.2919 1.43274 +8940 6 4.77786 31.6555 22.5097 8.01353 -0.237295 6.09653 +8941 4 5.36252 32.2279 23.0433 -12.0801 1.27555 -9.50519 +8942 4 4.10079 32.1892 22.0697 5.55495 3.82082 5.5049 +8943 6 48.8707 26.8644 2.67473 3.24755 -50.1854 9.90243 +8944 4 49.7841 26.6767 3.05593 -33.5394 4.93648 -17.7122 +8945 4 48.3402 25.9967 2.74374 27.3415 43.0547 -3.91521 +8946 6 35.3704 23.2724 21.6151 -20.572 -8.60634 18.7236 +8947 4 36.1531 22.7653 21.8467 10.3528 0.763668 -1.9928 +8948 4 35.5272 23.8633 20.8878 14.153 10.3741 -19.8739 +8949 6 9.81162 37.7752 27.3066 -7.93747 -1.88745 -15.4111 +8950 4 9.56608 38.5967 27.7736 11.3364 -13.9943 4.65066 +8951 4 10.53 37.2723 27.7168 -2.00951 8.75096 9.6206 +8952 6 6.95784 10.9804 26.0002 -14.8513 -9.26658 -13.6642 +8953 4 6.43708 10.2284 25.6287 17.7452 16.2397 9.86134 +8954 4 7.32481 10.7062 26.8445 2.87033 -7.35616 11.341 +8955 6 15.9925 34.488 38.9165 -7.91378 13.4212 -4.2482 +8956 4 16.1125 33.5888 38.5756 -0.423195 -0.537141 7.5048 +8957 4 15.8451 34.497 39.8859 4.12272 -10.609 -16.5735 +8958 6 24.136 17.3087 36.1669 -1.30362 -38.1211 0.134245 +8959 4 24.6388 17.5417 36.9612 2.54889 -4.89456 5.81445 +8960 4 24.0565 16.298 36.169 6.29988 31.3296 1.89661 +8961 6 29.9661 19.0481 5.63552 -3.51045 -24.0694 26.081 +8962 4 30.059 18.4844 6.44318 1.40084 7.89656 -22.1005 +8963 4 29.4651 19.7932 5.9612 -6.50009 17.0844 0.645364 +8964 6 41.2323 14.2118 25.8708 0.538972 29.9242 -13.4546 +8965 4 41.1167 15.1135 25.4912 3.21098 -20.1981 4.76589 +8966 4 41.3237 14.3734 26.8138 2.01946 -2.10135 6.77926 +8967 6 30.5977 17.7991 37.3648 -2.09385 13.2702 -7.29075 +8968 4 30.1274 18.3693 36.6865 13.7219 -8.47854 26.2153 +8969 4 30.6897 18.2674 38.2325 -7.09621 1.58925 -18.9017 +8970 6 36.2622 35.7606 28.8616 -21.9344 -15.8478 13.9239 +8971 4 36.666 34.9659 29.2737 0.470987 14.2463 -5.72758 +8972 4 36.9609 36.34 28.5862 17.8584 7.52692 -3.58957 +8973 6 0.186361 37.881 20.3783 -19.4052 1.06805 -13.5296 +8974 4 0.625244 37.258 20.9754 1.43275 1.23053 -1.08677 +8975 4 54.3963 37.4077 20.0073 13.2242 8.68111 6.51083 +8976 6 49.5157 39.5849 25.2719 1.34086 -27.0873 28.6785 +8977 4 49.1738 39.8396 26.1677 9.83442 -4.23573 -27.15 +8978 4 49.8309 38.6394 25.3482 -11.1501 31.2987 0.525887 +8979 6 21.6501 10.2052 29.3652 1.38747 -32.8599 -17.8213 +8980 4 21.4815 11.1062 29.1158 -2.57329 19.5966 11.1399 +8981 4 21.7962 10.0736 30.3036 1.32123 13.0863 10.38 +8982 6 36.4484 30.062 0.133613 20.0221 49.2239 1.07318 +8983 4 36.3691 29.4748 41.3122 -8.72629 -28.1564 -18.1683 +8984 4 36.9877 30.812 41.6437 -16.8233 -22.5363 23.3328 +8985 6 35.2366 23.3806 39.1473 20.2218 -67.2813 -35.6269 +8986 4 34.8925 23.3776 38.2436 -2.85003 -5.00903 7.3464 +8987 4 34.9678 24.1769 39.4749 -24.7984 75.1446 29.9953 +8988 6 25.4958 17.6356 38.7131 -1.05403 5.23051 -13.5311 +8989 4 26.2557 17.1099 38.9745 11.6052 -6.82876 2.03202 +8990 4 25.6896 18.4914 39.1039 0.551448 5.55093 4.31103 +8991 6 32.6851 1.71412 15.3757 -17.1832 -26.0249 32.2484 +8992 4 32.9133 1.90091 16.3255 -0.281287 1.06348 -22.8896 +8993 4 32.1369 0.878474 15.451 14.5551 28.5253 -7.92953 +8994 6 2.74577 26.2334 40.164 -3.83079 -17.2464 -24.8373 +8995 4 2.52975 26.8073 40.8689 -10.0885 25.811 23.4985 +8996 4 3.46379 25.6906 40.4857 13.7859 -11.3271 -3.22577 +8997 6 25.4247 39.5803 6.65235 -3.20662 25.1889 -29.4644 +8998 4 26.0108 39.0547 7.19361 -10.0861 -10.9475 13.3666 +8999 4 24.4797 39.508 6.87242 11.3389 -11.2764 10.0712 +9000 6 3.89558 2.45526 21.1915 20.3615 -74.5786 -16.468 +9001 4 3.45835 1.54866 20.9342 19.9424 46.4596 11.9477 +9002 4 3.20863 3.06758 21.3193 -35.5841 29.5388 2.2294 +9003 6 19.428 35.9937 6.17834 -35.0483 8.79483 10.2733 +9004 4 18.6638 35.8781 6.77432 14.6839 -5.07873 0.0324743 +9005 4 19.0495 36.6291 5.56439 9.71061 8.85688 -10.7695 +9006 6 53.6717 10.8593 34.7958 -7.0633 -31.3632 -8.45381 +9007 4 53.6341 10.4895 35.6991 7.39736 18.8685 -12.2464 +9008 4 53.8829 11.7827 34.7263 4.03482 19.5096 16.0301 +9009 6 51.2684 14.0949 34.672 -8.65676 -1.63762 -26.9588 +9010 4 50.7715 13.5641 33.9816 13.3581 12.906 22.4054 +9011 4 51.0369 13.7812 35.5532 -5.90867 -9.66849 3.74112 +9012 6 14.4369 40.0234 28.032 -17.7583 12.3896 33.8878 +9013 4 13.8707 39.2432 27.9284 6.73847 -3.79593 -5.43806 +9014 4 14.0697 40.4885 28.8439 14.5888 -10.3946 -25.5694 +9015 6 36.0586 40.8581 1.30985 34.3129 5.11816 -1.28261 +9016 4 35.3876 41.022 1.96214 -5.4524 5.11716 12.4526 +9017 4 36.8901 41.3246 1.61712 -30.5352 -10.0787 -2.88322 +9018 6 32.5955 21.8673 9.61487 11.2903 3.47268 22.8686 +9019 4 32.2562 21.1899 9.03409 -3.19899 -6.31213 -16.1683 +9020 4 32.8032 22.6511 9.09762 -2.66985 0.307575 -11.8305 +9021 6 53.7554 11.4583 10.0657 12.5408 -15.0223 -21.3323 +9022 4 54.7025 11.5478 10.261 -4.15933 2.55001 3.12883 +9023 4 53.7605 10.7769 9.36125 -9.51558 7.63224 9.70748 +9024 6 25.4365 2.06658 35.0039 -16.8474 18.4627 -14.151 +9025 4 25.5892 2.94197 34.5728 -1.09755 -16.5277 9.12484 +9026 4 24.4603 2.05675 35.1439 15.8828 -2.54758 -2.86629 +9027 6 38.4258 16.3759 27.0837 10.3035 -3.82582 33.4754 +9028 4 38.4229 16.0362 28.0039 4.2105 -6.34073 -14.2668 +9029 4 38.1536 17.2766 27.2341 -1.96409 14.1736 -9.55492 +9030 6 11.9898 11.8134 38.076 -13.826 -2.82892 7.4824 +9031 4 12.2944 12.4411 38.7385 15.2198 2.85174 -2.31876 +9032 4 11.0532 11.721 38.3132 2.05768 -5.32701 -10.6008 +9033 6 21.1746 40.7334 25.8979 40.4357 -13.6237 -24.6728 +9034 4 20.6698 41.4315 25.4918 -16.6357 14.348 -0.996217 +9035 4 20.789 40.494 26.7242 -19.3448 -1.94923 24.9485 +9036 6 5.46053 31.2633 28.1043 10.2831 7.82506 0.3012 +9037 4 4.85681 31.7249 27.5011 4.53193 2.9664 -2.03256 +9038 4 6.18919 31.875 28.3487 -9.19227 -4.78386 -2.03476 +9039 6 38.5722 10.4288 26.6273 1.75688 -6.42268 2.69181 +9040 4 39.2722 10.957 26.2192 0.13713 -2.38088 1.965 +9041 4 38.9883 9.93745 27.351 -0.726559 6.62326 -4.692 +9042 6 34.5654 22.2334 5.77474 -10.6824 6.04198 20.2303 +9043 4 33.6505 22.4646 6.03122 6.34024 -5.77168 -8.80249 +9044 4 35.1097 22.5906 6.49609 1.67963 -6.25138 -9.01327 +9045 6 19.5088 23.4111 8.91157 10.1707 -16.3121 14.7533 +9046 4 19.7449 23.1021 9.7973 -5.16612 6.6008 -0.0119594 +9047 4 19.9964 22.8054 8.35541 -0.106246 2.40248 -11.9056 +9048 6 19.7526 39.1673 18.9392 3.41392 2.41259 -7.44399 +9049 4 20.3112 38.9942 19.7162 -9.66179 4.90282 -1.08801 +9050 4 18.9888 39.695 19.2431 8.6955 -6.10904 -0.220035 +9051 6 19.0066 16.6479 37.8897 24.9266 -16.0788 2.00499 +9052 4 18.1904 16.5622 37.4269 -20.8911 -0.0800444 -12.5516 +9053 4 18.858 17.3198 38.5387 -2.83386 13.0664 11.2213 +9054 6 46.1457 18.3015 34.4662 -13.7163 3.02283 10.6817 +9055 4 46.1788 17.7584 33.6837 2.50627 -7.36872 -12.652 +9056 4 45.2295 18.6352 34.4793 7.83367 -3.11582 0.242547 +9057 6 37.6724 4.92727 10.6572 20.6306 -0.498941 -29.5329 +9058 4 38.5268 5.23995 10.2493 -20.9001 -6.48587 16.5696 +9059 4 37.1025 4.69637 9.88262 10.9132 7.05613 26.3995 +9060 6 51.9879 36.0003 6.84307 -0.0349375 1.28893 10.7684 +9061 4 52.0937 36.793 6.30051 2.19835 -5.62517 4.5242 +9062 4 52.7425 36.0295 7.48232 -7.26034 2.01661 -20.7899 +9063 6 26.6747 12.3215 0.993928 -15.5873 -26.456 -19.7503 +9064 4 26.4829 12.3908 1.92985 -0.4811 3.80705 11.7504 +9065 4 26.1241 11.5295 0.732228 15.7893 19.669 4.48242 +9066 6 51.344 35.7707 13.5244 -1.45768 15.8539 -2.86245 +9067 4 51.4515 36.3837 12.7824 1.55721 2.40741 1.90229 +9068 4 51.4783 34.9191 13.1366 6.57206 -21.9808 -6.55402 +9069 6 1.98876 3.63996 24.5779 3.53339 50.093 -23.5227 +9070 4 1.66274 3.05681 25.2088 -14.7773 -39.8355 33.4132 +9071 4 1.68527 4.50485 24.9411 8.95614 -12.6616 -11.2736 +9072 6 33.5242 15.2767 16.4494 0.0755523 4.59339 -41.038 +9073 4 33.5553 15.5138 15.4787 -3.36737 -9.15609 28.4742 +9074 4 33.81 16.089 16.8707 2.78154 5.67933 12.8052 +9075 6 10.7376 26.5972 37.3568 -53.543 46.6204 -3.13137 +9076 4 10.2745 27.0143 38.1249 4.48347 -4.84659 -12.5134 +9077 4 11.4659 26.2171 37.7527 59.8403 -33.1666 26.4091 +9078 6 39.618 8.36935 32.0025 -18.1555 9.41152 20.5333 +9079 4 39.1948 8.91554 32.6893 14.8148 -9.04413 -3.7523 +9080 4 39.059 8.55692 31.2545 -3.75745 -0.899113 -17.0741 +9081 6 48.8678 24.2325 11.5968 8.56011 -30.9839 -7.0275 +9082 4 49.2355 23.3258 11.4382 -10.5357 21.2684 5.64902 +9083 4 49.6052 24.6956 12.0119 -1.11745 3.30341 0.0123828 +9084 6 15.7966 8.52145 22.5402 1.04041 9.04678 1.57429 +9085 4 15.9271 8.56462 21.5825 -0.708828 -3.15413 5.43528 +9086 4 15.5351 9.42629 22.7739 -0.982858 -3.13072 -0.606507 +9087 6 16.9647 23.5461 7.94634 -33.4976 4.63454 -7.56842 +9088 4 17.0449 23.8842 7.03772 17.2153 -3.19264 11.7182 +9089 4 17.7681 23.4723 8.45101 25.4501 5.7081 -7.03081 +9090 6 42.4788 26.856 6.32162 3.09129 16.6976 -8.96027 +9091 4 41.8509 27.5547 6.55233 4.05081 -5.7053 1.31186 +9092 4 43.1337 27.3683 5.79469 -5.76138 -9.42264 4.17624 +9093 6 36.7899 4.80361 30.039 -6.11534 9.52442 2.68488 +9094 4 37.0233 4.89717 30.9689 4.03122 4.23205 -0.240484 +9095 4 36.2783 4.00567 29.9694 -7.15291 -10.8132 -0.980928 +9096 6 45.6188 11.6101 3.31184 17.0103 13.4398 12.4748 +9097 4 45.8378 10.6807 3.43524 1.11174 -8.0511 2.33471 +9098 4 46.2756 12.0957 3.86714 -12.3909 -9.3108 -12.4209 +9099 6 24.8953 36.3829 21.2888 -10.2051 -4.79955 -3.81503 +9100 4 24.4947 36.4635 22.1668 10.8854 5.06826 1.45383 +9101 4 25.816 36.6689 21.3407 0.621807 2.11968 6.76072 +9102 6 31.8152 24.7333 2.44905 16.2387 18.0677 -0.666362 +9103 4 31.5926 23.846 2.71622 -2.49338 -12.6998 4.18613 +9104 4 32.794 24.7683 2.43834 -16.3068 -2.39725 -1.0987 +9105 6 24.1315 21.9864 37.2328 -11.9778 41.7246 15.7453 +9106 4 24.1531 22.9879 37.1682 1.73438 -35.6656 2.36813 +9107 4 24.6319 21.6756 36.4808 8.45953 -1.72708 -12.6617 +9108 6 37.1993 11.5451 15.0492 16.5469 7.10484 -0.527568 +9109 4 37.9299 11.7412 15.6355 19.6925 -10.3737 -3.43176 +9110 4 36.5282 11.9944 15.5291 -36.4248 10.8574 4.75341 +9111 6 36.4804 20.3298 41.7865 -14.7619 -38.0306 11.4639 +9112 4 36.2972 19.4996 41.306 -2.7681 3.32899 7.9346 +9113 4 36.9128 20.8369 41.1399 19.1888 26.5648 -23.5244 +9114 6 32.0378 37.9251 32.6621 -20.5074 -27.3147 -8.21436 +9115 4 32.5159 38.6908 32.9558 4.48721 20.2349 -0.22713 +9116 4 31.3298 38.1855 32.0457 8.6638 5.37323 8.26506 +9117 6 12.0353 39.9275 22.5179 -19.9222 21.97 13.043 +9118 4 12.3148 40.8142 22.1582 -9.65836 -22.9721 12.3921 +9119 4 11.2968 40.0749 23.1753 26.4497 -1.81786 -22.4595 +9120 6 26.3421 1.33641 19.2861 18.8224 -12.0939 15.9617 +9121 4 26.8564 0.711595 19.8557 -14.3211 16.2919 -14.6989 +9122 4 26.7977 2.18849 19.3545 -2.53714 -0.144297 -3.51109 +9123 6 5.91333 14.3058 5.68279 5.58536 -17.6781 -26.1831 +9124 4 6.35226 14.1008 4.80839 -10.2521 5.5819 21.3359 +9125 4 5.1498 13.7016 5.72209 7.95548 1.62414 0.442017 +9126 6 13.3681 23.0924 19.1542 -7.87238 10.4677 13.234 +9127 4 14.1204 22.8148 18.6592 15.6827 -8.39443 -13.4152 +9128 4 13.7622 23.5769 19.9007 -5.90355 -3.89356 -3.96922 +9129 6 23.3981 15.0775 9.7431 -16.2896 3.15659 0.0853289 +9130 4 22.5416 14.6758 9.94236 4.38356 -3.66538 1.71341 +9131 4 23.1926 15.7004 9.03099 5.43777 4.93098 -2.67512 +9132 6 49.5886 13.8369 18.4468 -1.57371 0.160736 10.1606 +9133 4 48.8725 13.4353 17.9701 -17.3578 -11.6866 0.338485 +9134 4 50.0711 14.2256 17.7358 20.2332 17.1818 -14.445 +9135 6 41.7455 5.66741 41.8995 19.0031 1.14603 7.86728 +9136 4 42.5946 5.93333 0.438032 -19.5636 -6.95293 -12.6597 +9137 4 41.9891 5.05837 41.1762 -2.65724 5.24908 4.18535 +9138 6 17.2511 35.5417 2.55548 5.2045 0.397579 1.12894 +9139 4 18.2067 35.619 2.48098 6.39755 9.05508 3.07921 +9140 4 17.0886 34.6316 2.34229 -4.27489 -11.2961 -3.02567 +9141 6 49.7041 19.8589 40.2412 43.8428 -27.8149 3.09893 +9142 4 49.318 19.0163 40.5437 -5.31641 8.5833 -2.14336 +9143 4 50.6864 19.6533 40.2493 -27.6084 12.6334 -3.24012 +9144 6 38.3071 5.82731 32.0534 -20.9946 -3.84451 12.3853 +9145 4 37.8352 6.48986 32.6009 6.6943 -7.79079 -6.23381 +9146 4 39.2094 6.1245 32.003 13.4939 6.60324 0.292563 +9147 6 16.2694 6.84865 34.0054 -5.49782 1.82896 8.85162 +9148 4 16.5828 6.71308 33.1028 9.77351 -3.29618 -0.21352 +9149 4 16.9894 6.61948 34.6288 -2.86373 0.259786 -9.19674 +9150 6 33.6805 18.2019 10.4544 40.2358 -26.4835 -11.4715 +9151 4 34.2537 18.8203 9.96489 -9.74865 -7.15313 7.53482 +9152 4 34.2179 17.3378 10.5117 -27.819 38.8859 -1.78852 +9153 6 38.8962 33.7675 36.7566 23.6769 3.34821 -39.6603 +9154 4 38.383 33.5793 35.9171 9.63189 4.7017 21.543 +9155 4 39.855 33.8637 36.4612 -29.1237 -5.01255 9.39617 +9156 6 45.367 13.0954 20.2202 -17.4715 7.54819 27.7127 +9157 4 45.262 12.6289 19.4029 4.78427 -8.6457 -19.3619 +9158 4 44.4728 13.0498 20.6095 8.33403 2.77458 -3.46579 +9159 6 36.394 32.2025 8.83838 -5.39961 -0.779561 10.8196 +9160 4 36.3766 31.4559 9.45045 4.37642 -0.919546 -0.394048 +9161 4 35.9671 32.9207 9.33542 2.20851 -0.984819 -7.57369 +9162 6 7.93081 27.8143 6.16526 -1.31132 8.47671 -18.7581 +9163 4 8.2701 27.2941 6.88743 5.87236 -5.84072 6.56369 +9164 4 8.18271 28.7096 6.41539 -7.71007 1.94397 -1.55613 +9165 6 14.2797 4.87717 33.6823 -38.1616 11.9775 -32.0892 +9166 4 13.6477 5.2447 32.9846 23.9092 -16.4836 27.177 +9167 4 14.8408 5.63056 33.8658 12.4601 7.15131 6.13949 +9168 6 12.2578 8.65243 9.85848 -4.82715 -2.24662 -5.48477 +9169 4 12.6456 8.73928 10.7118 23.7259 9.48722 19.5525 +9170 4 11.4378 8.2214 10.089 -13.622 -8.47682 -13.9839 +9171 6 29.7261 31.9842 8.54243 -17.2145 25.3825 -18.7463 +9172 4 30.1804 31.833 9.34913 11.7892 -12.8324 21.9258 +9173 4 29.6399 31.1708 8.03663 5.85846 -6.51984 4.51241 +9174 6 22.3891 10.8785 21.4662 8.73739 -5.18702 6.55753 +9175 4 21.8037 11.1386 20.7714 -14.2177 0.338512 -24.4291 +9176 4 22.2091 11.5521 22.1168 2.36988 5.22793 14.1218 +9177 6 54.1797 27.5396 12.9955 26.3988 -18.3584 17.6139 +9178 4 0.160041 27.5787 13.0909 -6.71045 -5.06664 4.99497 +9179 4 53.9798 28.2721 12.4475 -15.7222 27.4826 -22.0497 +9180 6 7.71973 13.812 20.0407 -34.9077 17.0186 -30.9147 +9181 4 8.32362 14.1503 20.6766 20.1403 8.526 22.156 +9182 4 7.35968 14.6399 19.6101 8.73645 -26.5601 8.16532 +9183 6 19.7932 0.841243 24.7869 -1.21084 18.2021 12.2367 +9184 4 19.1669 1.06895 25.5104 7.86649 -0.445713 -11.3386 +9185 4 20.4073 1.61074 24.7031 -15.4775 -18.2332 3.4978 +9186 6 3.01312 10.0986 2.94829 -27.2997 12.089 -8.88269 +9187 4 2.52802 10.9508 2.83041 12.1807 -20.5661 3.67701 +9188 4 3.91304 10.3154 3.17839 17.025 6.36995 4.07131 +9189 6 15.8857 13.0124 24.0049 15.5529 -4.67501 -5.43243 +9190 4 15.0856 13.5308 24.0834 -5.13718 6.9751 3.63726 +9191 4 16.3233 13.139 24.8614 0.105722 -2.17465 -3.852 +9192 6 17.0852 4.33969 26.9167 21.5143 -4.09641 1.48348 +9193 4 16.9912 4.27513 25.9666 -0.355278 1.74978 -10.9716 +9194 4 18.0601 4.31538 27.0472 -16.9044 3.21714 1.83131 +9195 6 33.6168 39.4091 10.6433 -2.74936 14.5855 -32.8438 +9196 4 33.9454 38.5625 10.8616 8.60753 -33.4012 17.9817 +9197 4 33.8375 39.4354 9.68976 -8.01757 16.2593 11.171 +9198 6 36.2326 1.10755 13.0941 -10.1125 -3.31802 -5.56412 +9199 4 35.6506 0.392496 13.3579 -10.7819 -8.26966 -9.36682 +9200 4 36.7599 1.20112 13.8707 17.1874 9.72194 12.3054 +9201 6 40.862 19.2925 5.11158 -0.402197 -15.9333 44.5432 +9202 4 40.3871 19.4968 4.34679 -15.032 12.6888 -52.1674 +9203 4 40.1189 19.1611 5.72143 13.4548 0.976419 10.4775 +9204 6 2.35452 37.5497 10.1778 32.5589 0.132829 19.8916 +9205 4 3.04634 37.0953 10.7141 -10.4583 9.64478 -9.40166 +9206 4 1.85979 36.8581 9.75685 -15.4906 -16.9123 -13.0897 +9207 6 8.10293 29.0334 15.8847 29.3895 -23.7333 0.542295 +9208 4 9.03551 28.6824 15.7668 -29.6945 17.5799 0.572456 +9209 4 8.18484 29.8326 16.4072 3.85606 5.10463 3.42896 +9210 6 47.3132 26.514 12.5427 4.56821 28.1849 -37.0073 +9211 4 47.5111 27.2634 11.8891 -8.56493 -28.9528 31.2783 +9212 4 47.3519 25.7475 11.9556 -1.34676 -3.33794 4.54904 +9213 6 33.5886 17.4994 0.666432 -7.15301 -2.01744 8.51284 +9214 4 32.6196 17.5968 0.930917 31.8637 -19.8727 -7.43903 +9215 4 33.9404 16.5735 0.747207 -21.2256 15.6146 2.50609 +9216 6 38.9757 15.6004 36.3686 4.31005 -11.6982 -11.4703 +9217 4 39.1719 14.652 36.4294 -3.02079 4.3409 1.02949 +9218 4 39.3764 15.8813 35.5317 -1.53099 5.14915 -0.246696 +9219 6 34.8198 34.351 9.37266 2.46578 -22.7668 -16.8875 +9220 4 35.3506 35.0289 8.96724 14.9634 11.0695 -15.2613 +9221 4 34.4558 34.8191 10.0913 -19.5236 18.4179 34.8179 +9222 6 44.9681 2.58102 14.7874 21.8703 21.498 2.75759 +9223 4 44.0383 2.44896 14.9383 -16.9502 -5.72583 1.77575 +9224 4 45.1679 3.47323 15.1264 -3.49788 -5.23458 -3.46791 +9225 6 42.6138 38.2902 19.8325 18.6047 12.1973 -29.2276 +9226 4 42.7029 39.1598 19.3445 -0.0117609 -27.8329 13.7468 +9227 4 43.0921 37.6383 19.2425 -13.1736 20.1758 17.0781 +9228 6 18.6869 26.7647 30.2619 -33.6624 -6.012 -17.6355 +9229 4 18.1258 26.7596 29.445 14.3051 -0.674317 21.614 +9230 4 19.5687 26.9499 29.9621 19.5047 4.84041 -5.57389 +9231 6 38.8661 37.7421 16.4836 -9.78438 -6.51051 7.80135 +9232 4 38.7478 36.8102 16.2377 -7.01003 6.44463 1.75037 +9233 4 39.8105 37.8446 16.5724 18.1337 5.4462 2.51551 +9234 6 49.3017 9.82081 12.5377 12.9664 18.8416 30.0962 +9235 4 48.8085 9.39111 11.8826 -17.6666 -23.7062 -38.8329 +9236 4 48.5984 10.2345 13.0427 4.42646 9.01279 7.79627 +9237 6 43.2246 7.36268 19.8264 -1.99344 11.167 24.993 +9238 4 42.5572 7.81175 20.4051 12.7818 -10.9207 -14.0727 +9239 4 44.1025 7.51179 20.2375 -5.96789 -3.6213 -7.06723 +9240 6 36.3461 38.714 4.42821 -2.77728 9.11116 8.98737 +9241 4 36.8002 39.5234 4.70824 5.05063 -6.10698 -1.49424 +9242 4 35.4394 38.9016 4.68929 -3.84434 -7.68842 -3.54296 +9243 6 27.8 17.802 15.105 0.992317 -7.44098 -8.78046 +9244 4 27.5393 16.935 14.729 3.58787 16.6938 2.50389 +9245 4 27.8517 17.6781 16.0585 0.147204 -0.130556 3.13955 +9246 6 18.0837 3.77506 37.3201 -10.3169 -12.5791 -10.2966 +9247 4 18.6663 3.07474 37.0146 -2.03685 -5.25132 -4.70316 +9248 4 18.6637 4.19691 37.9324 10.4473 20.1285 21.3871 +9249 6 7.71395 11.575 6.52222 6.59834 -21.2687 20.1659 +9250 4 7.75955 12.4254 6.93969 -0.705235 13.257 9.50392 +9251 4 7.66936 11.739 5.5978 -3.42683 1.36071 -31.338 +9252 6 31.4909 14.3449 18.0451 -1.46982 -12.276 17.176 +9253 4 32.1287 14.6507 17.397 7.38292 5.65775 -7.44504 +9254 4 32.0331 13.8785 18.7146 -6.90734 4.25576 -5.30331 +9255 6 50.3346 30.4143 8.91505 10.1635 2.25064 -1.90936 +9256 4 49.6557 30.853 8.39615 -4.47176 4.28708 -1.87566 +9257 4 50.0231 29.531 9.11356 -2.73977 -1.84009 2.34474 +9258 6 42.1686 10.1057 12.759 16.2008 2.03437 -4.20809 +9259 4 41.2649 9.83209 12.6487 -17.4225 -8.81494 -4.74081 +9260 4 42.1292 10.8861 13.3105 -1.28453 5.18814 5.66853 +9261 6 37.773 3.09539 32.5582 -5.24906 4.78867 -2.39206 +9262 4 38.0736 3.99724 32.5969 21.7942 11.3719 -4.3192 +9263 4 36.8519 3.25822 32.7463 -19.4678 -11.9252 3.55114 +9264 6 35.7586 13.1005 19.2721 9.99017 -22.7528 0.0781354 +9265 4 36.1308 13.8223 19.7887 2.26592 2.2719 5.61144 +9266 4 36.2509 12.2915 19.5517 -9.66412 15.3645 -2.5809 +9267 6 45.5318 4.12684 21.4944 7.1153 -16.224 0.922187 +9268 4 45.5588 4.23252 20.5315 -1.8039 6.94223 3.67507 +9269 4 45.7548 3.18328 21.6122 -5.15542 13.2346 -0.821742 +9270 6 16.876 1.8608 31.4782 -3.84426 -17.9183 -35.0426 +9271 4 16.0621 2.17388 31.0004 15.6258 0.929179 27.3362 +9272 4 17.1381 2.25043 32.3174 -12.6393 14.1325 4.42374 +9273 6 14.0947 4.88307 23.5769 -10.6061 -28.6131 16.0669 +9274 4 13.8059 5.76888 23.7237 -2.25817 32.588 -6.82267 +9275 4 13.6039 4.42137 24.2892 9.04813 -2.88937 -11.9208 +9276 6 38.3208 33.7635 12.3625 -16.3318 -7.70706 -26.0192 +9277 4 38.1373 32.9408 11.8506 0.297782 14.7405 12.2413 +9278 4 39.1486 33.6221 12.8093 16.0136 -1.39994 11.7584 +9279 6 35.6849 3.05753 37.6719 3.72695 1.1389 -16.7638 +9280 4 35.1101 2.5063 38.212 -4.0587 0.687226 6.19097 +9281 4 35.8854 3.87289 38.1447 -1.86413 5.08658 8.8135 +9282 6 31.3385 37.395 35.3723 -12.2239 -8.91609 34.0312 +9283 4 32.2231 37.7249 35.5382 9.93962 6.70229 -3.55138 +9284 4 31.225 37.4524 34.4409 4.86335 0.993516 -31.3389 +9285 6 52.0614 11.7324 14.0182 20.1458 -4.7001 -39.6215 +9286 4 52.0268 11.0667 13.2735 0.495691 14.4049 24.809 +9287 4 52.7095 12.4171 13.7023 -24.8081 -17.2766 13.6147 +9288 6 26.3478 3.42613 41.0189 1.80794 1.58056 -19.374 +9289 4 25.6151 4.01507 40.9203 -25.7718 5.99951 16.8165 +9290 4 26.7914 3.68675 40.2055 22.5797 -12.3384 -0.204994 +9291 6 24.3802 34.9453 11.1613 28.8325 38.7039 -6.19962 +9292 4 24.3515 34.6784 12.0652 -4.50215 -14.1529 28.2178 +9293 4 23.9023 34.3202 10.6558 -20.492 -31.6724 -14.1682 +9294 6 32.0094 7.59293 31.2147 -3.26399 8.81733 5.62682 +9295 4 32.0976 7.47613 30.2777 2.1706 -0.778595 -17.1478 +9296 4 31.5266 8.43606 31.2858 0.565291 -7.84955 4.65821 +9297 6 28.7282 2.60805 0.424377 -15.1279 1.50585 -5.39222 +9298 4 29.2952 2.36387 41.5859 -5.33248 3.35197 5.42737 +9299 4 27.7901 2.65331 0.119401 23.4632 0.0509354 2.06419 +9300 6 42.125 19.2126 9.86039 10.7783 -7.26578 33.4177 +9301 4 42.6695 19.2101 10.7019 -20.1092 0.869002 -30.5597 +9302 4 41.4363 18.5278 9.96356 3.48727 6.10561 -4.25932 +9303 6 33.0194 27.0842 8.32851 16.6372 -6.55357 -10.7525 +9304 4 33.8911 27.0001 7.90493 -7.38323 -0.765342 -2.5624 +9305 4 33.2437 27.3744 9.20899 -0.425855 7.33259 11.2137 +9306 6 4.16433 8.30018 19.1575 16.0783 -2.51395 5.95143 +9307 4 4.71165 7.98099 18.3991 -19.3854 5.29846 8.38252 +9308 4 3.22273 8.32359 18.9288 3.05712 -5.28108 -12.2975 +9309 6 20.7745 29.1912 37.0609 -25.9123 -20.3491 -5.83769 +9310 4 21.0713 28.277 37.0594 -15.1664 -12.7508 0.5123 +9311 4 21.6013 29.5933 37.1743 32.957 35.4267 8.73191 +9312 6 13.1089 4.99809 10.9103 2.80775 13.1965 -7.17841 +9313 4 13.4591 5.85092 11.2415 -2.5949 -14.1267 -1.88178 +9314 4 12.7051 5.16456 10.0462 -1.2434 3.82389 2.90473 +9315 6 37.5087 18.1031 32.5343 20.0502 31.699 14.1692 +9316 4 38.1018 18.8164 32.1735 -18.2411 -21.7333 4.56216 +9317 4 37.2041 18.4813 33.3903 1.90105 -7.17599 -12.7275 +9318 6 17.7655 33.2839 30.7231 12.9967 19.9173 -17.9311 +9319 4 17.8488 34.0437 30.1253 -3.68331 -4.50715 1.49576 +9320 4 18.5638 33.345 31.2563 4.57995 -0.934488 4.72964 +9321 6 23.1969 32.7832 9.90135 2.14033 10.4984 -5.43395 +9322 4 23.4737 31.9362 10.2634 3.28964 -4.66398 1.33779 +9323 4 22.2469 32.7196 9.72631 0.753558 0.42269 -0.434072 +9324 6 14.8911 9.35828 34.246 -8.54616 0.784134 0.501674 +9325 4 15.4672 8.59016 34.1372 5.2294 -0.0873347 -3.8795 +9326 4 15.23 10.0905 33.7027 2.53244 -1.05206 0.202563 +9327 6 31.1203 39.3599 38.5719 4.30147 -17.578 8.21172 +9328 4 31.5941 38.6377 39.0527 -10.1026 17.4492 -9.05875 +9329 4 30.4019 38.9077 38.1077 1.84332 2.82409 1.03593 +9330 6 5.29005 34.4279 28.2716 -0.764315 -10.945 -9.90403 +9331 4 5.24266 35.3772 28.447 -0.427568 -2.02335 -2.15628 +9332 4 5.18384 34.3192 27.3143 2.05225 4.04935 9.99949 +9333 6 30.3216 21.6974 14.1256 3.24994 1.03129 -0.468005 +9334 4 30.4656 20.7696 14.235 0.884625 -14.9253 16.053 +9335 4 30.3519 21.7638 13.1772 -0.963709 16.3006 -15.7103 +9336 6 23.8542 39.0018 28.2919 38.6077 23.8437 -8.99828 +9337 4 23.8505 39.6937 27.6143 9.44649 3.56781 3.51793 +9338 4 23.0185 38.6309 28.1896 -50.029 -28.3524 0.952356 +9339 6 9.61332 13.5451 16.4567 13.7131 10.5156 -25.323 +9340 4 8.77595 13.0917 16.3907 -9.93448 -5.52821 8.41851 +9341 4 9.74204 13.8378 15.5322 5.69689 -3.544 12.5309 +9342 6 25.9753 6.18174 15.7989 23.4837 -9.67411 23.9067 +9343 4 26.0218 6.10484 14.8454 5.11216 -1.95092 -7.71856 +9344 4 26.7445 5.66727 16.1761 -27.6477 18.1551 -17.3833 +9345 6 15.9921 33.6419 22.5616 2.25497 8.86036 -26.9911 +9346 4 16.0049 34.0594 21.6804 -4.22455 0.568633 15.0409 +9347 4 16.1032 32.7157 22.281 -1.05219 8.42244 16.6761 +9348 6 40.6812 13.5416 12.1266 -4.5396 -12.3661 6.74099 +9349 4 40.4134 12.947 11.4149 -4.75912 -2.4644 -8.17888 +9350 4 41.058 12.9332 12.7776 -0.386087 8.79442 1.8157 +9351 6 35.5875 40.2809 31.6993 12.2791 -13.6127 -29.8257 +9352 4 35.948 40.913 31.0681 -4.17713 12.2213 7.17402 +9353 4 35.6271 39.4709 31.1475 -9.59473 3.36029 20.1077 +9354 6 19.3493 17.5927 17.849 24.123 48.8902 3.26857 +9355 4 19.9577 18.423 17.9915 -34.5112 -38.8316 -9.06029 +9356 4 18.6928 17.806 17.1645 6.15508 1.01267 5.31501 +9357 6 7.96541 28.082 10.7737 20.0283 17.3944 8.50509 +9358 4 8.43659 28.8341 11.2297 -13.1431 -15.7733 -11.3814 +9359 4 7.20109 28.4458 10.3015 -0.215648 4.06143 0.688545 +9360 6 32.1489 39.5869 16.6475 -7.37335 1.81146 -4.92627 +9361 4 31.705 40.4043 16.3332 3.90743 -15.5774 4.53996 +9362 4 31.4977 38.8659 16.5723 3.01217 10.596 3.08762 +9363 6 35.8095 2.63602 18.127 2.07542 -14.8225 4.13142 +9364 4 34.8947 2.32962 18.1713 7.15775 -3.6283 3.09768 +9365 4 35.7135 3.4873 17.7367 2.81673 20.5762 -11.5045 +9366 6 14.9588 39.9585 36.8943 -2.86001 -28.3727 24.0409 +9367 4 15.4545 39.4909 36.2335 10.0689 -8.68258 -13.459 +9368 4 15.0094 40.8569 36.655 2.72867 44.443 -9.08423 +9369 6 18.3115 32.3916 11.4639 8.59274 12.4423 14.7113 +9370 4 18.6438 32.5881 12.3772 -9.2478 -5.5834 -23.9484 +9371 4 17.8762 33.212 11.1576 6.35145 -13.5457 0.164794 +9372 6 14.605 10.3819 4.99774 5.57597 -6.68493 12.6773 +9373 4 13.677 10.4388 4.75284 -6.10435 1.24571 -3.75468 +9374 4 14.6185 10.047 5.91478 4.2493 4.0336 -10.9734 +9375 6 2.02851 14.3408 39.1627 -4.03313 12.5981 -1.48522 +9376 4 2.74992 15.009 39.2086 -14.5088 -8.45155 5.07373 +9377 4 1.21458 14.679 39.6124 19.1623 -3.42757 -8.41789 +9378 6 7.58709 14.1522 32.4651 10.4977 19.6861 -0.504887 +9379 4 6.93593 13.6605 32.9674 -3.57672 2.30039 3.8359 +9380 4 7.5987 15.0834 32.797 -1.90079 -22.9019 -5.87851 +9381 6 6.15309 23.123 37.664 -26.7168 -14.8188 -11.2926 +9382 4 6.52639 23.9838 37.7378 17.5333 20.6862 9.20416 +9383 4 5.45539 23.2608 36.9958 8.40974 -10.7335 8.81374 +9384 6 37.3009 22.5422 4.44282 21.6187 66.9857 0.670839 +9385 4 36.5208 22.1217 4.15693 -30.5217 -23.5005 -12.8181 +9386 4 37.1232 23.5227 4.23696 10.5274 -41.8214 11.62 +9387 6 47.1349 31.0113 5.88613 -14.3653 5.64202 -58.02 +9388 4 46.9542 30.9019 6.7933 -9.29323 -2.10558 39.1512 +9389 4 46.2627 31.2059 5.44524 20.5013 -7.22248 10.5418 +9390 6 54.8094 25.5909 34.9286 -5.37395 41.5808 12.672 +9391 4 54.0266 25.5089 35.4943 -0.981006 -11.4098 -6.26775 +9392 4 0.0616925 26.543 35.1263 -1.5494 -32.4448 -11.2369 +9393 6 37.1551 2.08197 4.79239 -12.5712 23.0197 -22.5278 +9394 4 36.5844 2.86136 4.61445 9.59981 -14.8952 -2.62483 +9395 4 37.0798 1.96202 5.72873 2.5296 -7.23911 19.6989 +9396 6 22.5239 28.6012 8.91155 -7.98869 19.6075 21.4366 +9397 4 22.8946 28.4124 9.79991 -0.853296 -5.89568 -17.4096 +9398 4 22.801 27.9767 8.25343 10.1708 -14.6558 -3.7409 +9399 6 8.64208 27.1509 24.5664 -38.2161 25.5543 4.78276 +9400 4 7.71753 26.8887 24.5582 -5.16372 11.0804 -0.386298 +9401 4 9.04357 26.3309 24.4724 40.7169 -47.477 -5.23592 +9402 6 1.14997 23.727 2.4309 6.46058 8.65979 -14.8341 +9403 4 1.18232 23.9936 1.48373 -6.63581 -4.99587 16.5657 +9404 4 0.310199 23.2733 2.54924 -0.981545 -0.950126 -1.89037 +9405 6 54.3702 30.2259 27.0243 -0.035121 6.58363 -4.50453 +9406 4 54.2615 29.4654 26.4339 1.23903 8.74071 -4.24792 +9407 4 54.6064 30.9974 26.4582 -3.83852 -12.4126 5.30421 +9408 6 0.386829 8.42023 23.9938 5.00922 -16.8445 -6.80376 +9409 4 1.36083 8.4508 24.0758 -8.17173 1.21512 3.08891 +9410 4 54.9524 8.88826 24.7258 9.13745 3.54566 6.13736 +9411 6 16.8971 28.5839 33.3722 23.8511 -30.9569 -4.46587 +9412 4 17.442 28.7831 34.1436 -6.82268 9.96305 3.46007 +9413 4 17.4403 27.8723 32.949 -23.4552 19.8179 6.40974 +9414 6 33.6969 30.8931 0.141175 14.1795 0.777253 -0.635822 +9415 4 34.6278 30.5945 0.162696 -6.8513 6.78484 1.91826 +9416 4 33.3211 30.3583 41.3463 -2.66034 -4.05802 -0.0970656 +9417 6 16.2525 21.5202 34.1552 3.2099 -15.0674 -0.387853 +9418 4 16.0099 20.7546 33.5903 4.90739 13.2878 5.87792 +9419 4 16.6977 21.1376 34.9376 -8.96682 7.2262 -10.6242 +9420 6 0.22977 17.7868 35.7492 -9.57638 -14.7124 1.37696 +9421 4 54.2434 17.9569 35.6827 28.6901 -4.22084 5.11773 +9422 4 0.351694 16.93 36.209 -4.1051 13.1178 -5.65765 +9423 6 16.8289 12.2962 0.019427 11.8958 12.8939 11.6481 +9424 4 17.3016 12.8498 0.703368 -12.3262 -21.137 -14.7379 +9425 4 16.4403 11.4936 0.411486 1.39397 8.07719 2.11333 +9426 6 8.24246 9.54397 36.2629 -25.8472 21.2414 2.40819 +9427 4 7.81464 8.9356 36.8788 1.26461 -2.06425 2.56422 +9428 4 7.48979 10.0869 35.9067 16.4576 -8.29365 1.86334 +9429 6 48.5761 26.718 39.8382 -16.8767 -13.2223 25.9758 +9430 4 48.2189 26.9037 38.9774 0.202946 6.43929 -15.4249 +9431 4 49.4865 26.9849 39.8847 17.129 6.93076 -9.10183 +9432 6 35.4777 1.07865 23.1156 20.3084 9.46551 28.8556 +9433 4 36.0215 1.72656 22.6213 -7.75205 -10.5654 8.45632 +9434 4 35.804 1.12911 24.09 -10.3378 -1.68949 -45.1242 +9435 6 20.2777 30.6326 19.3782 17.168 -16.4055 9.77372 +9436 4 20.2499 31.0311 20.2788 1.56461 -6.55175 -10.0354 +9437 4 20.938 29.881 19.3855 -20.6701 22.3694 2.2449 +9438 6 44.3702 15.9458 1.58361 10.9348 22.193 31.2112 +9439 4 44.4077 15.6379 2.51116 -1.71559 -1.42871 -18.164 +9440 4 44.6431 16.8967 1.66823 -9.97295 -22.8516 -13.6111 +9441 6 53.8845 34.4651 10.6068 -24.0145 7.95167 -19.3224 +9442 4 54.4361 34.2696 11.3314 22.7066 -9.19703 33.7305 +9443 4 54.2985 35.2035 10.1555 0.2437 -1.83103 1.50375 +9444 6 46.1364 32.8471 33.519 4.96533 -12.2334 2.48444 +9445 4 45.9404 33.6629 33.0556 -3.66306 8.73713 -2.86335 +9446 4 47.0477 32.6179 33.2654 -4.26196 1.19291 1.09329 +9447 6 42.1324 21.9098 24.2239 34.4777 -24.9191 34.4505 +9448 4 43.0412 21.5159 24.3646 -28.4667 14.3091 -11.1056 +9449 4 41.7437 21.6811 25.0949 -3.80951 9.2794 -19.6729 +9450 6 8.14185 3.89847 11.6387 2.30661 -15.3192 6.95264 +9451 4 7.35197 4.1174 12.1322 -8.99547 12.8437 -2.29886 +9452 4 8.35392 3.05748 12.0535 10.9023 -1.5691 -3.31016 +9453 6 19.6413 41.6808 9.8267 1.07442 6.29255 0.337359 +9454 4 18.9204 41.094 9.57509 0.414049 2.67892 1.92063 +9455 4 19.352 0.205183 10.6506 0.427822 -12.2572 -10.0953 +9456 6 42.3157 8.41085 31.6785 13.3628 11.5473 -7.23952 +9457 4 41.3969 8.42848 31.9417 -9.73605 -1.80426 0.915182 +9458 4 42.5534 9.35818 31.5624 -0.333442 -16.319 1.99913 +9459 6 26.911 16.154 25.3637 -0.10907 13.2502 -20.6653 +9460 4 26.7939 15.8861 24.4207 -0.565005 2.37017 21.4763 +9461 4 26.6835 15.4121 25.9182 -3.52016 -12.4926 6.14171 +9462 6 48.2345 6.48613 12.6212 -1.55264 -8.09911 -9.8466 +9463 4 48.9652 6.31914 12.0011 -5.93235 3.28214 2.19301 +9464 4 47.4516 6.10442 12.1764 7.36669 2.93589 5.65527 +9465 6 53.4556 41.5274 30.6561 0.928349 -3.66285 -10.4005 +9466 4 53.9738 41.8466 29.9077 -1.68735 -3.84443 -4.80087 +9467 4 53.7246 0.16796 31.3785 5.2081 5.34012 15.7103 +9468 6 47.0719 22.4215 31.8177 3.79963 28.0651 -15.4962 +9469 4 47.8542 22.5824 31.2379 -15.4047 -7.22606 14.7582 +9470 4 46.5391 23.2393 31.6689 5.43499 -22.2824 10.2038 +9471 6 19.5241 5.44646 15.2431 57.7261 9.00726 -25.1025 +9472 4 19.973 4.5781 15.2547 -6.4602 7.66804 1.10752 +9473 4 18.6769 5.33307 15.596 -47.9766 -8.78418 19.1468 +9474 6 14.6808 30.2445 33.392 16.954 11.9814 -17.0239 +9475 4 15.1668 30.8865 32.8123 -10.4914 -16.0898 10.6301 +9476 4 15.2553 29.4559 33.3904 -4.22445 9.80292 -0.52553 +9477 6 28.4427 24.2289 10.4187 -0.774793 -27.6212 -36.8967 +9478 4 29.277 24.4414 10.8128 10.21 14.4589 20.8069 +9479 4 27.7162 24.5027 10.9517 -9.91177 12.6254 22.5109 +9480 6 5.25429 14.4357 24.4952 18.8694 8.38265 -3.5804 +9481 4 4.38598 14.1455 24.6681 -43.369 -9.18674 12.4123 +9482 4 5.45154 13.9758 23.6794 9.52503 -2.95522 -10.1363 +9483 6 26.3476 19.2988 19.1857 11.4015 -18.2951 -12.5804 +9484 4 26.5417 20.1869 19.4853 3.52858 10.6793 1.31948 +9485 4 27.146 18.9308 18.7141 -21.2465 13.7562 17.259 +9486 6 28.5834 7.44603 13.1845 8.68409 29.8386 11.3246 +9487 4 28.3961 6.55455 12.9442 -2.45324 -19.0833 -9.20205 +9488 4 29.0571 7.89665 12.4686 -5.14786 -6.54739 -1.73865 +9489 6 5.35742 27.1473 37.0464 13.0843 -4.728 13.8292 +9490 4 6.09472 26.8663 37.6487 -17.7636 2.66278 -18.049 +9491 4 5.49884 28.0724 36.7882 1.93418 -3.90879 0.386893 +9492 6 53.1466 13.4128 16.1104 33.6732 -23.607 0.886679 +9493 4 54.0532 13.0537 15.8959 -24.4904 18.1541 2.55443 +9494 4 52.6056 12.6236 16.2807 -0.490038 10.6025 -2.0621 +9495 6 45.4595 1.03561 24.6152 0.883869 7.22473 8.82703 +9496 4 44.8005 0.912307 23.9218 -0.0838502 -1.3445 -1.23214 +9497 4 44.9845 0.757767 25.4168 6.19386 0.932014 -5.94613 +9498 6 50.1542 2.38642 13.9319 -2.4774 12.931 -1.3926 +9499 4 50.7815 2.76975 13.3044 0.014285 -4.08681 1.38242 +9500 4 49.5062 3.09016 14.0651 -1.63783 -0.639647 1.83323 +9501 6 19.5885 31.0175 39.1657 -10.9837 -21.6636 -18.6241 +9502 4 19.8079 30.3148 38.4832 -5.60324 21.7545 20.6111 +9503 4 18.6148 30.9453 39.3442 26.0441 2.6939 -5.02925 +9504 6 19.2491 14.7106 10.8907 20.9533 -11.5465 -13.087 +9505 4 20.0062 14.1954 10.4207 -44.2836 18.7066 28.5885 +9506 4 18.7045 14.0688 11.3882 14.1221 2.37282 -8.47947 +9507 6 4.44986 39.5549 20.1348 -7.46971 20.8744 22.4052 +9508 4 3.99116 40.4291 20.2667 12.3042 -22.0468 -4.08326 +9509 4 4.78876 39.261 21.0122 -11.398 5.88582 -21.7205 +9510 6 29.0264 13.3645 23.891 3.80322 20.0192 21.3715 +9511 4 28.7263 12.4558 23.8574 1.87437 -3.97007 -2.19356 +9512 4 28.9189 13.5991 24.8488 7.01015 0.856522 -27.3099 +9513 6 17.0674 2.76528 17.6511 13.6679 -9.88609 -24.0062 +9514 4 16.9089 3.43106 16.9566 -0.337692 -4.66999 2.92783 +9515 4 17.7694 2.16287 17.2836 -16.7881 13.7863 9.44417 +9516 6 43.472 18.0456 17.7207 2.90116 -6.00314 -10.3001 +9517 4 43.5328 17.0661 17.6262 0.602958 19.7978 9.46789 +9518 4 43.5843 18.2505 18.6627 0.176297 -8.32564 -1.3476 +9519 6 25.7838 40.7303 1.24723 -3.64329 26.5644 -28.0564 +9520 4 26.2198 41.3001 1.88369 1.46132 -2.86659 8.1156 +9521 4 25.5777 41.3986 0.532216 -2.57635 -28.6607 13.7824 +9522 6 0.458758 22.8928 6.22327 -2.28892 -3.37321 -2.62932 +9523 4 0.911995 22.0955 5.88137 -3.49653 6.37629 4.11618 +9524 4 1.15027 23.4262 6.63616 1.38998 -0.611711 -3.15133 +9525 6 26.2502 35.0072 18.629 11.2346 5.37396 -16.6635 +9526 4 25.9102 35.926 18.5821 -1.77201 -16.2127 4.61622 +9527 4 25.7094 34.5197 19.2578 -0.594129 4.22999 1.61862 +9528 6 16.1509 31.8837 7.54876 40.1408 -29.5169 -1.86921 +9529 4 16.9528 31.2446 7.38162 -38.5191 36.6879 6.5811 +9530 4 16.2422 32.6162 6.9246 8.25996 -4.45471 -3.71716 +9531 6 22.9569 16.8424 28.5503 -18.0144 15.9011 -12.9281 +9532 4 23.0242 16.0615 27.9964 2.65193 -8.47258 -0.731728 +9533 4 22.0914 17.2685 28.2981 23.9965 -14.5366 15.8079 +9534 6 48.817 29.3453 32.1483 10.2159 -3.67765 25.2301 +9535 4 47.913 29.23 31.8533 -10.4354 1.38436 -5.08298 +9536 4 48.8482 28.9579 33.0615 0.343667 8.53482 -20.1614 +9537 6 13.1275 24.857 5.54597 -15.7655 12.0094 -10.6158 +9538 4 12.8967 24.1126 4.95892 -3.19147 7.26676 2.83523 +9539 4 12.4206 25.5605 5.45199 17.9822 -22.1189 1.55356 +9540 6 10.967 20.7149 15.8389 3.49035 -8.57129 -4.90872 +9541 4 10.8232 20.5385 14.8814 6.84933 2.21154 19.4522 +9542 4 11.8211 20.2878 16.0966 -18.2767 7.30584 -13.8769 +9543 6 13.8574 18.376 6.9425 -18.5688 18.5302 -26.9748 +9544 4 14.0551 19.3329 6.99178 3.58444 -10.9562 5.12073 +9545 4 14.2751 17.8929 7.64202 12.8225 -6.30863 19.0643 +9546 6 13.8485 12.9413 30.6405 -7.33075 -24.1801 -9.47477 +9547 4 13.9233 12.3923 29.8469 14.5901 9.31788 -1.12157 +9548 4 13.0284 12.552 30.9634 -3.13873 11.8242 15.1361 +9549 6 17.1199 6.33729 31.2705 58.4108 60.4292 21.9502 +9550 4 16.7347 7.19592 31.0485 -2.55536 -2.82538 -1.05014 +9551 4 16.4932 5.72664 31.0455 -61.4006 -55.6776 -22.0804 +9552 6 7.63858 23.4232 20.5528 2.70849 -2.51933 -11.6338 +9553 4 7.34936 23.0623 19.6936 2.42656 1.66026 8.60009 +9554 4 8.06294 24.2698 20.3247 -2.54411 -7.58863 2.30144 +9555 6 15.6012 36.6828 25.6308 12.0382 0.865576 2.42327 +9556 4 16.546 36.4866 25.8589 -19.7129 13.5166 -7.57965 +9557 4 15.5566 37.5233 25.1245 15.7859 -9.47529 6.9914 +9558 6 0.738662 10.4099 22.1708 -26.6289 -22.4058 -14.7131 +9559 4 0.0268398 10.3645 21.4686 20.8647 0.21224 20.3485 +9560 4 0.555589 9.63254 22.7491 3.84168 18.0907 -12.5939 +9561 6 33.5034 17.3959 33.5951 21.201 30.6084 -13.4811 +9562 4 33.5895 18.3893 33.3705 0.776259 -45.1899 5.95193 +9563 4 34.1847 16.8766 33.1005 -9.04546 14.4589 8.38708 +9564 6 21.6622 19.013 20.7578 31.9274 -22.1518 -4.15649 +9565 4 22.4096 19.6032 20.9777 -11.5486 -3.71871 -1.82252 +9566 4 22.1307 18.1402 20.6082 -20.9219 25.304 3.1187 +9567 6 41.7583 19.992 16.8792 -6.68772 4.02339 -8.69865 +9568 4 42.2438 19.1637 16.9575 3.64207 -5.49479 0.617993 +9569 4 41.579 20.1273 15.9247 3.71595 -2.33609 11.0843 +9570 6 12.0355 14.9654 17.6922 -21.5841 1.26502 -18.8824 +9571 4 11.2182 14.5976 17.276 14.8021 5.3277 12.4216 +9572 4 12.4319 14.255 18.1907 -0.352973 -10.2116 7.98966 +9573 6 23.0172 11.4191 40.7206 -10.7217 24.0381 44.0704 +9574 4 22.9528 12.3236 41.1181 -0.480688 -24.3492 -4.33206 +9575 4 23.3445 11.5906 39.8675 15.3819 0.516123 -37.823 +9576 6 21.0055 28.3299 24.5595 -23.1154 26.0001 -7.02903 +9577 4 20.2855 28.1767 25.1713 -12.8069 16.7504 -3.2857 +9578 4 21.5564 27.6405 24.838 35.6802 -30.9994 4.41974 +9579 6 19.406 13.705 31.9364 14.5236 -8.57279 10.3452 +9580 4 18.7521 13.9469 31.2876 -5.81883 0.611034 -8.78432 +9581 4 18.9142 13.6788 32.7621 -0.186305 1.04404 6.29106 +9582 6 21.5918 2.86134 24.7058 -12.3779 12.1824 -8.79066 +9583 4 21.7274 3.16074 23.7816 9.4572 -7.89437 13.7797 +9584 4 22.4025 2.45534 25.0386 5.22934 2.42127 -4.70961 +9585 6 11.3487 29.9838 18.827 10.5554 -3.16976 4.47537 +9586 4 10.5352 30.5203 18.751 15.2364 -2.61973 2.60085 +9587 4 12.0043 30.4181 19.4217 -22.0541 -6.82347 -15.9561 +9588 6 14.6417 22.3529 8.3686 35.183 35.1516 7.4005 +9589 4 14.0314 23.0645 8.61446 -9.87113 -8.59651 0.991548 +9590 4 15.5117 22.8693 8.31218 -34.203 -30.7208 1.23805 +9591 6 43.9533 23.6664 17.2647 -9.15762 31.6597 -10.4885 +9592 4 44.7744 23.2846 16.9678 11.7125 -13.1472 -3.62648 +9593 4 43.5104 22.9908 17.7726 1.91474 -8.51607 6.21827 +9594 6 28.003 25.5014 27.4986 6.23457 -29.1533 -5.23677 +9595 4 27.4849 26.2827 27.5489 -17.6876 27.9136 1.36856 +9596 4 28.906 25.8001 27.3829 8.21911 6.89622 0.0845564 +9597 6 19.1046 26.8047 33.1413 12.2661 11.24 -48.0243 +9598 4 19.0365 26.4782 32.1917 1.11076 11.999 35.7369 +9599 4 19.4769 27.7251 33.0545 -9.7287 -23.6705 8.34301 +9600 6 6.37289 19.3428 5.67363 -3.21133 -16.2285 8.07537 +9601 4 6.7336 20.019 5.09886 3.22925 8.22387 -6.14542 +9602 4 5.58923 19.7346 6.08082 -0.796808 3.74051 2.3056 +9603 6 37.4835 28.3972 9.67963 -16.8252 8.64443 -22.9196 +9604 4 37.8384 28.0931 10.5154 1.79485 -10.7977 1.13655 +9605 4 37.3056 27.6421 9.07717 9.05958 5.47813 21.4583 +9606 6 17.6994 27.086 11.7957 -23.9049 -9.71644 -0.114793 +9607 4 16.9894 26.5877 11.2784 19.3807 18.9653 23.0761 +9608 4 17.3772 27.2467 12.7205 1.32974 -4.86863 -22.184 +9609 6 12.8804 1.95044 24.1635 -16.9081 23.6463 -41.3936 +9610 4 12.0123 2.42693 23.9788 24.6345 -20.1638 18.4271 +9611 4 12.9602 1.63912 25.0531 -11.2641 -4.9093 21.6908 +9612 6 27.8486 37.1249 33.3037 14.5525 0.843809 -12.8082 +9613 4 27.8306 37.7566 32.5563 -0.261378 -9.54721 11.1245 +9614 4 28.4641 36.389 33.0416 -14.495 18.5162 4.94281 +9615 6 18.6769 12.3657 6.31954 -0.243732 -29.9473 12.6257 +9616 4 18.5317 11.3932 6.23771 0.963018 17.4883 6.62231 +9617 4 18.5535 12.6707 5.42951 -3.51714 10.9469 -19.8301 +9618 6 10.1845 29.3127 24.783 -1.36331 5.89889 -4.08473 +9619 4 10.7465 29.1085 25.5662 -10.353 -5.60455 -9.55427 +9620 4 9.5047 28.6152 24.6271 17.6265 9.93184 12.3415 +9621 6 7.25219 3.30976 16.2618 16.5712 6.01323 38.0962 +9622 4 7.85224 3.92676 16.743 -7.28275 2.21025 -21.7569 +9623 4 7.07626 2.67339 16.9792 -0.839688 -3.96601 -21.0406 +9624 6 32.2032 37.556 1.10106 -1.45173 2.30566 -1.67736 +9625 4 31.7319 37.0242 1.72254 -12.3544 -30.6614 1.12887 +9626 4 32.1826 38.3533 1.61216 9.84976 31.1212 -1.90535 +9627 6 10.4132 10.1536 6.41547 2.6172 -5.66149 -5.23088 +9628 4 9.51094 10.4988 6.43252 -1.43241 7.72691 5.99088 +9629 4 10.888 10.4598 7.20926 -10.4429 3.02901 -4.20627 +9630 6 16.1922 23.2473 37.3836 13.4596 17.9231 -6.20094 +9631 4 16.4628 23.5362 38.2769 -1.8179 -2.41291 -6.91424 +9632 4 16.622 23.8878 36.7607 -9.68345 -13.0364 13.8052 +9633 6 24.0933 14.3373 36.5438 -0.810617 7.47513 6.008 +9634 4 25.0172 14.0983 36.6068 9.64822 -3.29568 0.232999 +9635 4 23.7283 14.0715 37.4031 -3.57511 2.15125 -3.19243 +9636 6 27.4694 18.5535 28.7878 -22.2405 -8.90967 9.68842 +9637 4 27.2463 18.155 29.6474 7.14424 4.94771 -10.1046 +9638 4 26.6163 18.5328 28.3045 10.7583 2.44378 -0.411902 +9639 6 51.5617 10.4928 1.56364 -46.044 -5.31617 -17.9438 +9640 4 50.711 10.1131 1.91707 23.1705 13.8427 -10.0979 +9641 4 52.2015 10.4284 2.24991 18.8641 -3.04547 25.194 +9642 6 31.1163 39.6073 27.5052 16.7753 -4.77526 -29.689 +9643 4 30.6203 39.2762 28.2489 -5.6675 10.9492 15.0474 +9644 4 31.3773 40.5466 27.6182 -8.67746 -20.5696 10.3555 +9645 6 6.90447 35.9666 14.3264 -30.1691 -4.34312 14.222 +9646 4 7.61578 36.3042 13.808 21.2575 5.14969 -9.00238 +9647 4 7.11482 35.0613 14.5906 3.01946 -0.973686 -2.74545 +9648 6 45.5514 7.57029 29.1841 -25.615 -5.69379 -2.02895 +9649 4 44.9198 7.51228 28.4263 15.6429 0.393509 16.1679 +9650 4 45.0848 7.11279 29.9186 7.09759 5.05324 -8.24334 +9651 6 31.3626 20.5603 31.6216 46.5235 7.85379 -13.5612 +9652 4 31.9622 21.3332 31.7077 -20.5518 -6.12612 6.97271 +9653 4 31.9328 19.9839 31.0823 -17.3109 -3.90007 7.28444 +9654 6 43.0286 31.1606 10.377 -16.6603 7.93207 28.9623 +9655 4 42.0878 30.8529 10.4887 24.119 8.07098 -2.29185 +9656 4 43.3099 31.4942 11.272 -6.72297 -13.7816 -28.1326 +9657 6 50.925 25.5606 12.6461 -27.6852 -6.08767 20.8539 +9658 4 50.917 26.3683 12.1731 -8.31821 35.0391 -16.2433 +9659 4 51.8024 25.2628 12.5325 34.7451 -18.8429 0.848912 +9660 6 29.3305 2.97987 3.64738 17.2649 -36.5424 -5.61333 +9661 4 29.6156 3.84373 3.86529 8.03017 35.8359 9.57326 +9662 4 28.4158 3.03535 3.41816 -23.9953 6.75187 -10.8335 +9663 6 53.9216 32.1051 20.3724 -11.2223 -0.478332 -4.16652 +9664 4 54.8523 32.157 20.1701 8.27859 1.2318 1.83366 +9665 4 53.5473 31.7256 19.5583 -4.88871 3.83013 8.11791 +9666 6 41.7036 29.5569 6.48267 17.2638 16.7804 -5.64052 +9667 4 40.7698 29.5903 6.27928 -11.16 5.83742 -3.44443 +9668 4 42.1548 30.305 5.99503 -16.5783 -19.3567 12.2041 +9669 6 37.8345 24.5719 39.3019 -13.0469 -9.65298 -3.86921 +9670 4 37.225 24.2046 38.6488 4.5791 4.74434 1.49749 +9671 4 37.4276 24.3068 40.1372 5.55374 4.45167 1.85829 +9672 6 46.5621 27.5658 23.2944 -23.9279 -33.0439 -11.1022 +9673 4 46.4387 27.4786 24.2739 -2.64996 -4.90603 -22.3791 +9674 4 45.938 26.8598 22.8442 32.7587 35.3455 32.269 +9675 6 9.23408 27.197 8.34767 -28.7607 6.82988 18.9345 +9676 4 8.89078 27.6282 9.16421 9.10203 -8.06063 -16.3167 +9677 4 10.1694 27.1106 8.44975 24.8451 0.83524 4.07321 +9678 6 36.0586 34.168 13.9947 0.546429 -20.5208 -0.995849 +9679 4 35.8317 33.2019 13.9926 1.47243 21.3574 0.844463 +9680 4 36.7518 34.2454 13.3214 -1.12661 -0.38848 2.20278 +9681 6 51.6812 14.492 12.3108 14.2062 7.57429 -10.7818 +9682 4 52.2015 14.4126 11.4771 -7.23407 7.45688 18.698 +9683 4 51.902 15.34 12.7416 -3.60656 -14.3916 -9.37264 +9684 6 15.248 19.6366 32.4109 27.4357 -16.6396 -20.9158 +9685 4 15.2931 19.2358 31.5053 -3.54534 7.22564 18.4797 +9686 4 14.3328 19.7639 32.5881 -28.0981 2.1384 2.91772 +9687 6 27.6849 24.6479 38.3573 2.41004 -14.3506 -18.7558 +9688 4 27.9256 25.2107 39.0738 -0.349992 17.1553 25.2623 +9689 4 28.4455 24.6938 37.7731 2.45273 -2.47407 -6.18841 +9690 6 37.5344 9.26205 13.6222 2.62805 -1.42602 2.92011 +9691 4 37.9029 8.73293 14.3466 0.897712 0.834078 0.0180659 +9692 4 37.323 10.115 14.0326 -0.799981 -1.44542 -1.10758 +9693 6 20.9013 33.2307 26.2512 6.46074 3.54373 3.40895 +9694 4 21.2661 33.4546 27.1222 -3.70394 5.03607 -5.2507 +9695 4 21.0534 32.294 26.1755 2.06129 -12.757 -1.69162 +9696 6 6.58179 13.9421 35.2385 -0.161437 -23.8226 2.06013 +9697 4 6.46846 12.9778 35.1898 -10.847 5.63462 -0.921172 +9698 4 7.53649 14.0007 35.2781 8.40152 11.229 1.63712 +9699 6 10.0736 7.47184 6.87074 6.29005 1.76204 -5.26249 +9700 4 9.16789 7.18556 6.66525 -0.124912 3.45645 -0.864518 +9701 4 10.1825 8.41968 6.63706 -5.90018 -13.0861 3.35766 +9702 6 31.1989 5.96627 11.4256 47.5137 28.7614 23.6553 +9703 4 31.4466 6.13876 12.388 -20.2952 -9.94335 -33.1747 +9704 4 32.0308 6.26994 10.9806 -22.1211 -12.2896 5.82222 +9705 6 12.1387 3.84993 35.2935 2.49551 -0.304387 23.4243 +9706 4 12.8187 4.19174 34.7257 10.4227 4.50872 -14.559 +9707 4 12.5185 4.00559 36.1769 -9.60543 -1.42105 -7.76228 +9708 6 5.33665 6.07757 27.6447 8.69228 -34.5823 40.5077 +9709 4 5.10952 6.83187 28.1919 -5.14709 12.9851 -0.252954 +9710 4 5.24124 6.31071 26.7545 -7.00092 22.4827 -45.3835 +9711 6 13.1372 33.5675 1.68451 12.1014 31.5323 -4.45098 +9712 4 12.5865 33.1501 1.03303 -8.81838 -7.47149 -8.20936 +9713 4 13.3352 34.4765 1.32576 -5.5291 -24.3721 14.4697 +9714 6 44.6567 10.4099 29.0319 -12.4525 3.56979 -21.9228 +9715 4 44.5737 9.45178 29.0051 9.95574 -3.72472 2.79876 +9716 4 44.0317 10.7133 28.332 10.7873 2.60441 13.9487 +9717 6 9.14585 24.5947 6.38022 15.9839 26.3438 -7.73853 +9718 4 8.92734 24.382 5.47582 -9.1117 -9.61509 -8.5024 +9719 4 9.72625 25.3768 6.21639 -5.50996 -10.1894 15.5503 +9720 6 52.5653 27.2618 21.6392 -6.48047 6.16108 13.4347 +9721 4 52.5564 26.3196 21.8908 4.78081 5.6644 -14.1528 +9722 4 52.8195 27.3969 20.7225 3.24319 -11.7343 -6.41363 +9723 6 7.29679 16.9603 33.544 -1.27463 2.76823 -11.9762 +9724 4 7.39152 17.7215 32.9493 2.03275 -0.910573 2.88066 +9725 4 6.37085 16.7082 33.4809 -4.66481 0.778096 -0.770576 +9726 6 43.9289 25.2227 7.97871 -4.96366 -10.0233 8.38699 +9727 4 43.2519 24.7308 8.49213 12.2574 5.67032 -8.3389 +9728 4 43.4276 25.9018 7.51862 -3.04483 5.5605 -3.23664 +9729 6 2.07953 27.1233 13.6028 0.0104954 7.16496 -8.77242 +9730 4 2.15896 26.2371 13.9627 -2.1358 -7.6126 6.04882 +9731 4 2.6502 27.1018 12.8141 -2.23666 2.89631 3.72058 +9732 6 37.3141 18.284 2.18477 -5.94753 -1.23785 7.60386 +9733 4 37.4961 17.5691 1.55591 -3.17432 -0.490531 -1.7774 +9734 4 36.7255 18.8979 1.7415 -3.03937 1.4219 -5.67571 +9735 6 25.0022 10.0655 0.429871 -30.1443 -7.37242 -0.593153 +9736 4 24.272 10.366 41.7528 14.2211 1.75124 5.05026 +9737 4 24.5705 9.40237 1.00583 14.7283 12.1051 -6.86513 diff --git a/examples/amoeba/dump.ubi.1.test b/examples/amoeba/dump.ubi.1.test new file mode 100644 index 0000000000..743c5e68dc --- /dev/null +++ b/examples/amoeba/dump.ubi.1.test @@ -0,0 +1,19492 @@ +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +9737 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 5.4990000000000002e+01 +0.0000000000000000e+00 4.1909999999999997e+01 +0.0000000000000000e+00 4.1909999999999997e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 9.9631 5.60476 0.008413 6.29384 29.5246 19.0744 +2 2 9.59585 5.61686 40.5223 49.6095 -15.082 -19.7261 +3 2 8.19009 6.07902 40.3725 -38.3002 -36.0401 31.6494 +4 3 7.228 5.27674 40.5663 25.6537 34.3003 -15.2325 +5 4 9.24854 5.32486 0.671238 -4.4712 -3.37565 -7.28982 +6 4 10.3108 6.54317 0.309331 -11.8382 -28.5043 -8.77497 +7 4 10.7093 4.95217 0.170763 9.79439 -2.80927 4.02983 +8 4 10.3426 6.38567 40.0332 -19.5644 -29.2331 3.89265 +9 2 9.77742 4.13431 39.9813 -28.2245 -12.7597 2.79543 +10 2 9.48564 3.81758 38.4974 43.5672 -24.1926 -8.96475 +11 5 10.1176 2.11667 38.0047 -9.19737 11.9016 12.5734 +12 2 9.21456 1.10205 39.2112 31.2522 23.9396 11.6177 +13 4 8.99594 3.48122 40.5964 28.5446 19.8656 -13.413 +14 4 10.8136 3.75653 40.1807 -3.6049 4.77507 7.99264 +15 4 10.0744 4.47991 37.8007 -16.03 7.55553 14.4224 +16 4 8.42529 3.84402 38.2863 -20.8998 9.83371 -6.83213 +17 4 9.47601 1.46641 40.2263 -2.07893 -1.87234 0.341628 +18 4 9.53146 0.065851 39.1813 1.34892 -20.4385 -9.90461 +19 4 8.1577 1.22135 39.0727 -30.8502 -1.48556 -5.54631 +20 1 8.07565 7.408 40.3203 38.3461 4.68909 -14.5778 +21 2 6.84679 8.08521 40.1985 -59.0929 12.5985 8.76694 +22 2 6.18936 7.48414 38.9048 -11.7821 0.575019 41.3478 +23 3 6.7346 7.67531 37.8418 13.9355 0.826162 -41.115 +24 4 8.95137 7.92937 40.1018 -13.7432 5.12585 4.7357 +25 4 6.17099 7.78674 41.0889 17.7478 9.29385 -16.8634 +26 2 7.04543 9.68435 40.1788 6.06779 -36.4281 36.3417 +27 2 5.78315 10.5437 40.1541 10.0153 13.6856 -31.2349 +28 2 4.87823 10.4891 38.8981 8.0898 32.2503 -21.0798 +29 3 5.10035 11.2936 37.9551 -6.38068 -25.249 23.2549 +30 1 3.78765 9.69754 38.9447 7.74282 -10.5609 -2.0448 +31 4 7.77413 9.91905 39.4336 6.93206 10.4159 -38.5359 +32 4 7.65159 10.0279 41.0787 -15.5363 -12.6708 -2.68622 +33 4 6.21166 11.5927 40.0353 -14.0103 -9.11046 14.0038 +34 4 5.24199 10.4471 41.1154 -6.90019 6.03163 0.39253 +35 4 3.64982 9.13451 39.798 -8.63839 -3.4701 -4.98201 +36 4 3.18526 9.53497 38.0983 12.4509 11.2825 18.2671 +37 1 5.03649 6.76821 39.0271 29.2025 12.626 -49.9624 +38 2 4.1742 6.30537 37.9199 2.45922 -5.77224 11.4432 +39 2 2.7281 6.64357 38.2301 -33.27 13.9739 -28.2234 +40 3 2.48558 7.27851 39.247 -7.20167 1.94081 18.2399 +41 4 4.56901 6.92293 39.8729 -36.0812 -3.10094 47.9009 +42 4 4.41115 6.93099 37.0362 4.08063 -6.87028 -11.6053 +43 2 4.30896 4.77224 37.6863 5.60806 -34.2262 -10.7438 +44 2 3.61194 3.83713 38.7945 21.7291 41.8848 -7.6362 +45 2 5.81981 4.32753 37.5156 -0.302636 -10.5955 -12.2236 +46 2 3.74184 2.37563 38.4472 -21.3499 -20.7746 -35.862 +47 4 3.79188 4.51145 36.7016 6.3754 10.432 9.00978 +48 4 2.54774 4.08441 38.8361 -15.7139 1.18722 1.17999 +49 4 4.01487 4.13828 39.7949 0.987415 -11.5324 -1.87366 +50 4 6.38959 4.49596 38.46 -5.87199 -9.93517 1.91854 +51 4 6.36771 4.97617 36.7815 -14.8228 -10.6264 -0.132465 +52 4 5.90888 3.19548 37.1534 1.72477 39.701 11.5881 +53 4 3.39383 2.18531 37.3739 6.37275 7.50384 16.1992 +54 4 3.10231 1.69487 39.022 -2.76045 -1.11045 15.6564 +55 4 4.76015 2.00007 38.4839 16.883 -5.45935 8.37891 +56 1 1.68415 6.36719 37.3348 37.2769 -12.9922 15.6035 +57 2 0.304736 6.65563 37.6783 -19.186 -35.7743 -0.468083 +58 2 54.3638 5.41499 37.39 23.5408 9.01503 -19.9847 +59 3 54.8016 4.481 36.67 -18.0502 12.9096 17.6943 +60 4 1.81134 5.6821 36.5646 -2.38907 6.77101 2.69516 +61 4 0.26398 6.68603 38.7911 -5.02605 17.0245 3.77253 +62 2 54.6928 7.87629 36.9427 9.14228 37.5998 28.2049 +63 2 0.656467 9.08157 36.7109 -0.0956801 -8.96924 -14.639 +64 2 1.56488 9.23116 35.5658 -28.7887 -16.4207 21.28 +65 2 0.518242 10.1807 37.599 12.0453 -33.0617 -42.3022 +66 2 2.2549 10.4284 35.3456 -0.685553 9.51875 21.9154 +67 2 1.26608 11.2953 37.3573 -6.55985 56.8791 72.0683 +68 2 2.14201 11.4551 36.3269 43.9558 24.4422 -61.5967 +69 4 53.8494 8.28091 37.614 11.6877 -9.2043 -14.6276 +70 4 54.1796 7.56606 36.0251 1.84695 0.514683 -15.8045 +71 4 1.67027 8.40603 34.832 -2.56062 3.42592 3.08894 +72 4 54.8243 10.1788 38.4192 -16.1978 -2.83683 23.7337 +73 4 2.90465 10.5398 34.4584 1.04403 1.06161 3.93542 +74 4 1.2044 12.0958 38.199 3.2453 -15.1518 -32.2206 +75 4 2.76002 12.4636 36.1598 -24.4207 -43.5556 11.8549 +76 1 53.0705 5.5478 37.8043 -13.4682 25.7632 10.8407 +77 2 51.945 4.63101 37.5291 33.8243 -29.5042 -37.7332 +78 2 50.7838 5.44293 36.986 4.21111 -0.422475 -19.7833 +79 3 50.2621 6.29965 37.7355 -1.55474 -12.1519 -25.7528 +80 4 52.801 6.45436 38.3333 3.61532 -42.2821 -15.9338 +81 4 52.3053 3.83112 36.7028 -14.0928 30.7972 24.0178 +82 2 51.5456 3.79903 38.7793 9.75018 1.06621 4.26496 +83 2 50.3519 2.79661 38.4832 35.7171 10.1602 1.47909 +84 2 52.8174 3.02556 39.2171 -10.4567 -30.55 12.3487 +85 4 51.3202 4.51835 39.6193 -10.3559 -7.38818 -7.14654 +86 4 50.5612 2.13754 37.5331 -9.75373 16.6535 26.894 +87 4 49.4557 3.43665 38.3668 -10.8276 -7.01925 -6.76558 +88 4 50.2008 2.17632 39.4156 -2.83245 -1.1989 -13.0752 +89 4 53.3224 3.52205 40.064 3.32837 5.49303 2.41605 +90 4 53.5736 2.86114 38.4382 5.5955 2.25759 -8.48168 +91 4 52.5769 1.98664 39.5815 -0.855844 10.0945 -0.110617 +92 1 50.4393 5.19673 35.6351 -19.7264 9.67141 42.9571 +93 2 49.1691 5.71413 35.1171 8.57247 21.8964 -7.76629 +94 2 48.0882 4.65728 35.3507 -19.9883 30.8425 14.9148 +95 3 48.2827 3.53875 34.9335 -4.48089 -38.0316 -8.70437 +96 4 50.7426 4.33028 35.1784 2.31221 -1.81777 -1.86606 +97 4 48.9711 6.6281 35.7521 -11.2206 -0.672417 -16.6265 +98 2 49.2032 6.03091 33.5236 -0.851856 65.2811 26.1578 +99 2 47.9587 6.87959 32.9935 21.6676 -24.5773 11.3759 +100 2 48.0434 7.32811 31.5002 51.7858 -12.5586 -5.19204 +101 2 48.2074 6.22405 30.3724 28.294 -23.2516 17.4346 +102 1 48.1983 6.77555 28.9911 -71.9632 -28.6889 -6.605 +103 4 49.3393 5.11986 33.0139 -2.20502 -45.3575 -27.512 +104 4 50.0955 6.63289 33.1892 -0.645528 -4.64769 17.8413 +105 4 47.8013 7.74388 33.6913 1.36166 0.224784 -7.99748 +106 4 47.0904 6.22572 33.1496 -13.2574 -0.904539 -3.87726 +107 4 49.004 7.98659 31.3992 -27.9616 -9.11626 3.58403 +108 4 47.1978 7.96127 31.27 -20.0009 14.5444 -5.73856 +109 4 47.5417 5.33248 30.4619 -18.467 18.3391 -3.45282 +110 4 49.1897 5.66674 30.5732 -8.59668 22.4275 -14.4147 +111 4 48.9982 7.27964 28.7313 27.9214 19.6218 -9.55881 +112 4 47.3685 7.40493 28.8518 27.8731 -11.8414 7.77703 +113 4 48.0065 6.08598 28.2169 17.275 11.5652 28.2934 +114 1 46.9206 5.03778 35.9702 10.3577 18.9682 5.15831 +115 2 45.6557 4.25932 36.0398 9.08885 -0.641191 -14.1305 +116 2 44.8836 4.39003 34.674 17.924 -7.95306 73.8288 +117 3 45.3111 5.13887 33.8455 4.25406 24.8458 -47.415 +118 4 46.9247 5.98842 36.4259 -8.42518 -21.6093 -9.66 +119 4 45.9322 3.16772 36.074 -4.07513 2.77881 8.35057 +120 2 44.7235 4.66099 37.2497 -7.79148 27.6424 25.8282 +121 3 44.4559 6.1146 37.2032 37.085 -18.356 15.5747 +122 2 45.2448 4.26963 38.7181 22.7861 29.0575 -8.8559 +123 4 43.727 4.13168 37.1283 17.3832 10.5512 -0.864114 +124 4 45.2761 6.59903 37.5183 -34.0557 -21.4787 -11.7364 +125 4 45.8733 4.97275 39.4014 -10.271 -7.81482 -36.7347 +126 4 45.822 3.36133 38.5799 14.1835 -15.9263 3.29814 +127 4 44.4672 3.97387 39.4102 -27.3329 -5.40347 3.37723 +128 1 43.7561 3.68722 34.6039 -10.1769 -38.5504 10.0379 +129 2 42.7898 3.65331 33.5354 16.9998 -6.12306 -24.86 +130 2 41.7694 4.78815 33.7404 2.26966 -0.410412 -51.1213 +131 3 41.2522 5.37284 32.7445 13.6537 -18.3748 18.9894 +132 4 43.5295 2.98811 35.3697 5.99608 22.1557 -16.865 +133 4 43.3523 3.94914 32.5036 -19.5402 -19.5629 37.0771 +134 2 42.0755 2.18627 33.4863 21.9074 34.2086 -29.4327 +135 2 42.9391 0.859767 33.721 -6.85443 30.257 35.6042 +136 2 42.2358 41.4668 33.4285 -9.81834 -3.65893 -31.5778 +137 2 44.2283 0.854864 32.9471 53.2312 13.9788 40.9195 +138 4 41.6117 2.20331 32.4686 -4.39523 -13.2201 2.61812 +139 4 41.2586 2.27352 34.2121 -10.6776 -10.6054 4.67488 +140 4 43.2056 0.83773 34.8124 -0.343624 1.56324 -2.51079 +141 4 42.8118 40.5237 33.3983 6.69029 -0.569008 16.3673 +142 4 41.9597 41.5484 32.3684 -17.7546 -2.75522 -9.07631 +143 4 41.3245 41.3357 34.0216 -8.62626 -3.98831 3.9624 +144 4 44.0827 0.853311 31.8896 -3.53557 -4.02089 -36.565 +145 4 44.8236 41.822 33.2847 -5.06735 25.2561 -15.1823 +146 4 44.8583 1.80877 33.1923 -14.5958 -31.7921 -4.90526 +147 1 41.5264 5.19611 34.9737 -24.8334 44.6246 6.63495 +148 2 40.6685 6.33721 35.2699 -7.96634 19.3021 -16.1623 +149 2 41.3876 7.74941 35.097 -11.5591 -21.8484 1.81155 +150 3 40.7047 8.75309 34.8417 -6.4948 4.14558 0.128999 +151 4 41.7654 4.68652 35.8013 13.1043 -20.8107 18.8359 +152 4 39.8731 6.44712 34.4383 10.8594 -11.0445 14.3032 +153 2 39.8592 6.12601 36.6093 -15.5564 -7.24317 -37.5678 +154 3 40.7443 5.88444 37.6633 23.6025 16.5055 19.3857 +155 2 38.9047 4.85477 36.5395 -12.0583 61.1722 12.675 +156 4 39.322 7.07341 36.7706 -11.99 4.52079 9.89046 +157 4 41.1265 6.74598 37.8781 -3.93551 -10.4676 -4.79928 +158 4 38.0585 4.98564 35.7954 18.0693 -6.53498 -0.435941 +159 4 38.3566 4.77654 37.5171 8.14363 -6.92414 -3.72239 +160 4 39.543 3.99696 36.3828 0.165947 -30.6128 -6.86199 +161 1 42.7342 7.80416 35.136 -13.9315 11.8694 11.7976 +162 2 43.5142 9.02936 34.9481 17.7181 -46.9691 35.2138 +163 2 44.5073 9.42999 36.0349 -55.8537 -50.7646 50.0035 +164 3 45.375 10.2125 35.7599 43.422 25.9365 -4.74067 +165 4 43.1984 6.94617 35.4338 19.599 0.647333 4.29925 +166 4 44.1406 8.86955 34.0842 9.16679 3.97336 -28.1373 +167 4 42.9197 9.91228 34.8204 -18.5221 19.1219 -12.9063 +168 1 44.2798 8.93745 37.3587 -4.0043 10.1489 -58.0949 +169 2 45.1948 9.27519 38.4238 -4.17993 36.3676 -26.0855 +170 2 46.5575 8.73344 38.0061 12.5522 -20.4469 18.6928 +171 3 46.7331 7.49794 37.7681 -6.88831 31.8582 -6.20611 +172 4 43.377 8.45873 37.5311 9.37776 2.67644 11.4724 +173 4 45.2318 10.4158 38.3238 5.33405 -13.6354 14.6161 +174 2 44.7823 8.84756 39.8415 35.39 -32.4267 -9.44324 +175 2 45.5211 9.64049 40.9405 -33.0234 -16.4934 27.578 +176 2 45.0293 11.1067 41.0295 26.955 13.1382 1.75579 +177 2 45.9939 11.883 0.056845 5.44769 -3.52142 -7.77113 +178 1 45.567 13.2463 0.389189 -21.8942 22.5552 58.7427 +179 4 44.9649 7.71121 39.9163 -1.68078 22.7299 4.94117 +180 4 43.7292 8.96914 40.0006 -34.3585 3.91778 0.788359 +181 4 46.6326 9.56148 40.8729 -4.12637 -0.755434 -1.7729 +182 4 45.1589 9.15652 0.052119 21.5355 9.01144 -26.2886 +183 4 44.0384 11.1525 41.4882 -17.6691 -1.8484 1.78047 +184 4 44.9645 11.6456 40.0488 1.32443 -5.52779 3.51863 +185 4 46.9936 12.0079 41.4163 -11.0521 -7.71607 17.8496 +186 4 46.0863 11.2417 1.01939 6.64185 25.7549 -16.0759 +187 4 45.6176 13.9315 41.5535 6.39074 -1.54943 -2.93714 +188 4 46.1207 13.6426 1.21669 -15.3499 -18.2055 -38.2327 +189 4 44.572 13.3465 0.725918 28.6554 -12.4083 -12.8179 +190 1 47.5723 9.62675 38.0225 1.62241 16.525 -13.2778 +191 2 48.9413 9.31976 37.6447 28.3505 6.17866 3.85392 +192 2 49.7947 9.65595 38.897 -51.2415 76.6103 -24.0977 +193 3 49.6063 10.7902 39.4401 12.9093 -42.4425 -12.577 +194 4 47.4538 10.6389 38.3066 -1.81401 -22.4625 -4.08398 +195 4 49.0905 8.23756 37.4201 -8.03606 -0.867672 -0.903629 +196 2 49.3577 10.1392 36.3514 -15.5639 -8.86216 -34.5575 +197 3 48.3381 9.84531 35.2995 20.2521 4.60838 26.9691 +198 2 50.6821 9.73379 35.6575 -13.1705 -1.52152 26.2758 +199 4 49.443 11.2403 36.5183 -14.2645 -0.263993 8.70321 +200 4 47.5106 10.2398 35.5579 0.218555 2.62212 3.26783 +201 4 50.9323 10.3465 34.7687 -2.88514 -3.55444 -7.60949 +202 4 50.7732 8.65192 35.4951 -3.14548 -9.24106 -12.1943 +203 4 51.4763 9.94768 36.3674 17.1427 5.0591 10.0517 +204 1 50.5022 8.69828 39.4305 24.0939 -43.466 77.1583 +205 2 51.0483 8.71922 40.8082 -0.802123 10.2433 -32.8315 +206 2 52.5183 8.33859 40.7231 46.1376 25.1574 58.8821 +207 3 52.8914 7.33748 40.1143 13.0446 10.4001 -14.6089 +208 4 50.6189 7.73433 39.1341 -5.48208 -8.91176 -29.3848 +209 4 51.0045 9.75097 41.1725 -0.547397 17.2241 4.09797 +210 2 50.2922 7.85282 41.8455 19.6626 -50.7873 -7.63422 +211 2 50.2811 6.29504 41.471 -17.2864 -17.6708 26.7503 +212 2 48.8668 8.31684 0.212195 -17.3783 63.506 12.4232 +213 2 49.3691 5.38294 0.512646 14.3884 65.6628 -4.02696 +214 4 50.9326 7.9114 0.860642 -12.3241 5.1929 3.57402 +215 4 51.3127 5.83882 41.5287 -4.74499 10.5855 -5.5164 +216 4 49.8921 6.13652 40.4532 1.6457 0.843055 -11.9856 +217 4 48.0317 8.06123 41.424 13.0217 -7.20036 -2.54126 +218 4 48.8693 9.49201 0.254246 -0.917701 -32.4673 -2.46528 +219 4 48.5263 8.05212 1.23597 1.41612 -6.96817 -0.649274 +220 4 48.2816 5.57755 0.309314 6.34191 -1.32326 5.14384 +221 4 49.6363 5.72968 1.56057 -11.1106 -15.1353 -5.99489 +222 4 49.54 4.32324 0.397743 7.27301 -24.1582 -2.3836 +223 1 53.3925 9.14738 41.5454 -19.7766 -15.6836 -47.6014 +224 2 54.8543 9.29866 41.641 -12.5045 -20.0873 29.727 +225 2 0.407838 8.25913 0.762984 -29.7207 32.5524 -37.8245 +226 3 54.8643 8.2564 1.86493 17.0269 -29.0845 20.332 +227 4 52.9285 9.69819 0.341812 -9.11605 14.2566 13.2302 +228 4 0.291486 9.0623 40.6877 9.99865 -5.39191 -34.8298 +229 2 0.359683 10.7121 0.203065 -6.90664 -3.88067 -14.6485 +230 3 54.4765 11.8025 41.752 -11.2022 -21.2627 -5.88002 +231 2 1.6614 11.1001 41.4135 2.5167 -27.9916 -13.3179 +232 4 0.487415 10.6137 1.28953 0.410521 18.1219 13.0764 +233 4 54.0953 12.1937 0.613553 1.59003 1.59721 11.7532 +234 4 1.92456 12.0955 41.7398 14.8193 23.7252 4.53742 +235 4 1.52762 11.126 40.2979 3.61624 1.93597 7.36374 +236 4 2.5241 10.4069 41.6364 -8.38015 7.04993 1.52106 +237 1 1.45864 7.53391 0.367476 0.545631 9.71791 -21.8799 +238 2 2.25081 6.65311 1.15507 26.446 -0.0641839 -18.4938 +239 2 3.7671 6.96757 0.917085 -57.4365 -22.4689 85.9929 +240 3 4.15047 7.41488 41.7757 21.4144 12.1214 -29.7802 +241 4 1.8001 7.62601 41.3064 3.76941 -0.348546 3.21752 +242 4 1.98413 6.84865 2.19976 1.77378 -4.57114 13.3572 +243 2 1.98593 5.20856 0.673411 -39.0557 8.05152 -2.47083 +244 2 0.499001 4.77546 0.950638 51.92 -35.3278 3.54994 +245 2 0.302449 3.38226 0.307039 12.2804 5.92691 27.6936 +246 2 0.318833 4.59091 2.46762 -57.1886 17.9845 23.4913 +247 4 2.62035 4.47984 1.15306 24.0478 -12.5257 10.4353 +248 4 2.17019 5.14075 41.4887 6.74012 -0.473312 -2.7006 +249 4 54.8482 5.46061 0.448133 -33.0903 28.7369 -7.07308 +250 4 54.2241 3.15851 0.337643 -14.6094 -12.7265 -2.24176 +251 4 0.881511 2.58656 0.876485 -8.96903 11.0382 -11.5819 +252 4 0.635114 3.38296 41.1822 2.70741 -4.49002 -20.1461 +253 4 0.991181 3.80938 2.86091 2.53728 -4.51346 7.06316 +254 4 54.1796 4.30541 2.72425 38.6722 3.44969 -10.622 +255 4 0.495432 5.52724 3.08531 2.73328 -11.7655 -13.2166 +256 1 4.49387 6.66874 2.05101 59.25 35.5651 -63.8633 +257 2 5.97745 6.82619 2.08157 -13.5783 -40.6566 -15.6714 +258 2 6.57448 5.47381 2.54294 67.6927 12.9151 50.3283 +259 3 7.53922 5.43765 3.33186 -5.78511 6.85237 -12.8739 +260 4 4.10191 6.33546 2.9164 -11.2688 -10.0369 11.6191 +261 4 6.35409 6.85375 1.02753 1.73229 12.3732 3.55997 +262 2 6.47001 8.00523 2.96248 -35.1701 -2.47648 -9.01657 +263 2 6.52316 9.38515 2.26526 -52.089 -36.3571 -52.5381 +264 2 6.66039 10.5311 3.17647 23.2175 30.5211 32.7092 +265 3 7.81872 10.9467 3.49478 5.10838 -9.19539 -6.96115 +266 3 5.64173 11.0573 3.6767 -20.5888 -1.64097 0.158765 +267 4 7.42654 7.87231 3.41702 35.4584 -16.2138 5.63399 +268 4 5.81838 7.86205 3.84167 -4.54492 27.3919 10.2645 +269 4 5.56237 9.49095 1.59664 20.5708 1.89307 25.306 +270 4 7.29681 9.38215 1.47849 13.2355 1.21078 1.19218 +271 1 6.08096 4.31767 2.17259 -39.414 -15.8224 -24.7678 +272 2 6.39518 2.91476 2.36043 4.12081 37.0723 19.1814 +273 2 7.75633 2.62628 1.79624 63.8838 -9.4865 -25.3011 +274 3 8.33634 3.36937 0.946953 -27.4154 -16.213 26.3787 +275 4 5.28658 4.43126 1.58002 -24.0887 -1.16266 -20.2566 +276 4 6.54455 2.77577 3.45017 -8.86613 -5.70482 8.60941 +277 2 5.25427 2.02933 1.82805 -30.6144 -48.6247 5.61864 +278 2 3.85552 2.1153 2.66383 78.486 27.413 32.1434 +279 2 4.87851 2.27508 0.297641 -10.4566 -15.7718 22.2154 +280 4 5.65998 0.937168 1.99721 -15.6319 23.5495 -14.0675 +281 4 3.98898 1.63213 3.72107 -1.04911 23.3354 -24.3429 +282 4 3.15409 1.48884 2.20213 -45.477 -24.0418 -26.2275 +283 4 3.51802 3.20813 2.70746 -2.40249 -20.6527 6.6832 +284 4 4.39172 3.24426 0.119355 -1.44384 9.21297 0.0772101 +285 4 4.19746 1.51559 41.6955 12.4172 8.09212 16.5491 +286 4 5.82002 2.28129 41.6778 17.5327 1.3005 -22.4945 +287 1 8.43941 1.53208 2.30673 1.7292 42.4201 -39.4356 +288 2 9.76672 1.10452 1.81012 11.995 -19.5667 23.3003 +289 2 9.60964 41.7637 0.921245 4.05677 21.7498 -11.1929 +290 3 8.59567 41.087 1.06007 7.18507 -15.5872 -8.58634 +291 4 7.90606 0.81761 2.76924 -8.42032 -19.931 16.3865 +292 4 10.4026 1.87877 1.34085 -18.5158 15.1062 -12.7744 +293 2 10.6232 0.647963 3.0246 -34.7832 -39.5023 14.4787 +294 2 11.0993 1.6812 4.04079 16.2934 16.5377 23.708 +295 2 12.4719 2.27616 3.59128 -46.8378 -2.52013 6.7155 +296 3 13.4675 1.63575 4.02276 22.0629 14.477 -13.463 +297 3 12.4471 3.24187 2.73298 15.8946 -22.2661 28.0778 +298 4 11.4641 0.045385 2.63277 10.8271 5.92943 5.75519 +299 4 10.0353 41.7446 3.607 8.35649 20.5438 -12.0897 +300 4 11.2832 1.11765 5.0427 -4.51453 13.9694 -21.6118 +301 4 10.341 2.4932 4.3105 9.65416 -13.2167 -8.7997 +302 1 10.6494 41.4676 0.039711 8.78515 0.440053 18.9323 +303 2 10.7217 40.2184 41.1909 10.2574 -28.5822 12.1248 +304 2 10.6889 38.8907 0.171469 -17.3791 70.2346 -13.2363 +305 3 10.1368 37.8928 41.652 0.864281 -20.5458 12.6113 +306 4 9.82473 40.2067 40.5786 -14.2689 -8.84554 -18.4029 +307 2 12.0478 40.1799 40.3262 -31.3786 20.6535 10.6233 +308 2 12.4388 41.6551 40.4794 16.223 20.8678 -10.392 +309 2 11.8805 0.34241 41.7792 -28.1233 -36.7072 -34.4959 +310 4 11.9102 39.8982 39.2292 -1.08614 0.893428 17.4874 +311 4 12.7409 39.4563 40.8087 9.93344 3.46544 -3.32375 +312 4 12.0845 0.391154 39.5895 8.62314 -16.2997 14.2071 +313 4 13.5502 41.7447 40.5643 -1.70925 0.910467 -12.4735 +314 4 11.7305 1.40344 41.6414 -9.5626 24.5309 -2.35213 +315 4 12.5687 0.26268 0.684216 19.8182 -9.73862 27.9097 +316 1 11.1854 39.0885 1.40191 34.1901 -11.3327 18.3686 +317 2 11.4785 38.09 2.41707 -37.5808 13.2867 4.32174 +318 2 10.2405 37.7763 3.3402 -0.155099 -13.1844 6.87934 +319 3 10.4378 36.9653 4.27207 -11.6928 9.67513 -22.7546 +320 4 11.6756 39.9703 1.62918 -8.97807 -2.58442 -2.36164 +321 4 11.7153 37.147 1.89269 -3.37493 -11.1801 -2.58831 +322 2 12.7263 38.4682 3.25859 -32.7454 -15.529 27.3397 +323 3 12.5885 39.7408 3.87129 1.54426 18.5893 -11.5354 +324 4 13.5945 38.4441 2.61946 23.9879 5.88222 -14.7576 +325 4 12.9197 37.685 4.04183 -3.566 10.9198 -2.82194 +326 4 11.9285 39.8531 4.57214 8.5625 -16.1459 -5.7164 +327 1 8.98961 38.3717 3.14779 19.3135 28.1448 -76.0315 +328 2 7.78009 38.1002 3.90315 -4.26896 22.0341 0.229441 +329 2 6.83069 37.1869 3.18241 -25.8564 -25.3069 -16.1867 +330 3 6.84398 36.9785 1.97125 20.9058 23.903 -13.4458 +331 4 8.79049 38.9506 2.20714 10.5577 -30.8167 54.9659 +332 4 8.11274 37.5073 4.75427 1.14536 -6.32615 23.8911 +333 2 7.0077 39.4163 4.32571 4.21253 -4.87986 18.678 +334 2 7.75781 40.1168 5.42156 46.58 -14.1846 12.934 +335 3 8.30143 41.2262 5.21331 -14.6188 11.6514 -5.86083 +336 3 8.10545 39.4797 6.46784 -18.045 3.20128 -4.6129 +337 4 6.01572 39.173 4.78754 -1.72287 0.045533 -10.2864 +338 4 6.87032 40.2048 3.55457 -4.98407 -10.6589 -12.5629 +339 1 5.91154 36.4899 3.88964 18.6928 -0.691686 25.3425 +340 2 4.98537 35.571 3.20749 -24.0931 31.8814 30.8723 +341 2 3.79198 36.4499 2.67545 58.5623 50.3783 54.6165 +342 3 3.60244 37.6478 3.05835 4.98938 -42.2114 -12.2812 +343 4 5.945 36.5545 4.93654 -10.5756 -4.83423 -16.3239 +344 4 5.5221 35.038 2.40161 -3.05594 2.46612 -11.4716 +345 2 4.40384 34.4728 4.15145 -1.70261 45.9252 5.92389 +346 3 3.98498 35.0725 5.41787 -8.00202 -46.5665 -16.5053 +347 2 5.48475 33.4747 4.46048 0.249803 -29.9924 71.6177 +348 4 3.54337 34.0389 3.61058 -6.82183 -12.9435 7.69028 +349 4 3.62675 34.2747 5.86698 6.39679 27.749 2.05336 +350 4 5.85279 32.9868 3.57629 11.3184 -16.9973 -22.3871 +351 4 5.09248 32.6743 5.23041 8.97186 17.4623 -32.7541 +352 4 6.34746 33.9006 5.03324 -0.476546 4.78606 -11.5797 +353 1 3.00152 35.8184 1.87366 -46.1462 -42.5584 -55.0681 +354 2 1.77021 36.3468 1.35692 -36.7765 14.163 11.1031 +355 2 0.721356 36.5788 2.57059 18.2386 -29.7925 23.2574 +356 3 54.9678 37.5551 2.63992 10.9193 3.0322 -8.68025 +357 4 3.31287 34.9586 1.40066 1.19836 -3.77239 4.28893 +358 4 2.05059 37.3327 0.922928 -11.4048 10.7741 9.22697 +359 2 1.07197 35.5705 0.158527 41.3495 -39.9506 -9.05678 +360 2 1.73776 35.9497 40.6674 -26.4234 39.8053 33.0301 +361 2 54.5322 35.7209 0.133627 -14.8072 -12.0564 -1.20894 +362 2 3.23928 35.9487 40.63 7.11928 -24.1756 -12.68 +363 4 1.32474 34.4514 0.269568 -7.211 20.0201 5.35532 +364 4 1.47926 37.0502 40.6385 -3.87579 -7.90549 -26.2729 +365 4 1.36122 35.3789 39.7771 -4.72819 3.84386 12.155 +366 4 54.087 35.0558 41.2526 3.68912 7.63158 3.17282 +367 4 54.2076 36.7772 41.8385 0.949253 -6.55132 4.09096 +368 4 54.0676 35.3362 1.10912 4.22691 12.456 -17.368 +369 4 3.57003 34.9443 40.8434 9.13412 -24.8126 8.40569 +370 4 3.78301 36.5792 41.3142 5.34684 18.5101 18.1918 +371 4 3.6567 36.127 39.6372 -0.20476 7.44967 -14.9904 +372 1 0.712989 35.6055 3.58431 38.0557 9.26554 -59.6495 +373 2 0.05279 35.6483 4.83915 -15.0961 2.42646 38.658 +374 2 0.191347 37.0144 5.48801 7.00468 33.8104 1.40802 +375 3 54.154 37.7008 5.76148 35.4113 -11.6645 -8.2681 +376 4 1.23482 34.733 3.35856 -11.2418 4.01634 10.8504 +377 4 53.9671 35.581 4.69172 -20.2496 -5.13772 -12.456 +378 2 0.463881 34.4895 5.81355 17.031 15.9659 -33.5139 +379 2 54.8083 34.3393 7.16558 -30.7527 -16.2072 -11.1445 +380 2 0.00712 35.4957 8.10271 3.59003 -8.69902 15.3198 +381 3 54.0967 36.3529 8.34542 -1.77732 -9.94333 -12.6544 +382 3 1.07192 35.4587 8.7399 35.3598 16.353 18.5034 +383 4 1.56574 34.5304 5.94519 0.590681 0.639559 4.32925 +384 4 0.280894 33.5741 5.23349 -1.52963 -16.3279 0.16603 +385 4 0.223173 33.3947 7.64873 -6.8885 8.42796 -3.46601 +386 4 53.7112 34.1554 6.97481 9.65493 -2.46487 7.60139 +387 1 1.50649 37.4152 5.65526 -22.458 -31.2308 -17.0045 +388 2 2.02438 38.6379 6.15097 -3.22056 29.1656 36.4104 +389 2 1.58588 39.8651 5.40701 -13.5031 20.9194 -76.104 +390 3 1.07209 40.8553 5.93778 8.03965 -15.1327 11.1864 +391 4 2.24702 36.741 5.38136 -6.00826 1.88497 2.51587 +392 4 1.72629 38.833 7.20228 -22.1923 -11.9073 0.0585309 +393 2 3.51949 38.6121 6.24971 43.6984 -50.5664 -0.0787057 +394 2 4.11017 39.7004 7.10642 -5.48661 12.2779 -12.8977 +395 3 4.55887 40.7033 6.57435 6.12607 11.2234 -5.55098 +396 1 3.97545 39.5562 8.42942 -13.6958 7.00999 41.6346 +397 4 3.92653 38.5973 5.19958 6.67843 9.43594 11.2804 +398 4 3.90699 37.6191 6.72902 -10.8805 23.4385 -12.7616 +399 4 3.35162 38.8096 8.83526 13.2612 9.60447 -6.60232 +400 4 4.25023 40.3377 9.09595 -2.56729 -20.1743 -21.9158 +401 1 1.64621 39.8034 3.99517 -50.1719 52.4074 67.8966 +402 2 0.960547 40.8538 3.14427 -3.37695 -31.9032 -17.009 +403 2 54.4047 41.0035 3.47138 71.1401 19.2662 2.3079 +404 3 53.9887 0.221409 3.63964 -22.8765 18.4333 9.81455 +405 4 2.07659 38.9926 3.63308 18.9969 -31.9912 -34.7926 +406 4 1.39808 41.8727 3.34889 0.835518 -9.01277 1.27119 +407 2 1.14841 40.4887 1.56595 -9.49555 20.2148 39.7014 +408 2 0.469253 41.6189 0.677094 10.8075 11.2475 47.495 +409 2 2.6528 40.4777 1.25625 -15.459 -47.3647 -39.6369 +410 4 0.776571 39.4398 1.40308 -11.1955 11.1351 -6.38222 +411 4 54.3852 41.8501 0.825468 -5.0709 -17.7069 -2.05205 +412 4 0.696071 41.5065 41.5456 0.0730393 -4.82529 -32.9133 +413 4 0.904174 0.691668 0.985463 6.30616 -9.41897 -5.2369 +414 4 2.64269 40.3122 0.13166 16.7998 18.1471 15.5753 +415 4 3.13789 39.5289 1.58622 -1.56816 4.1145 9.56394 +416 4 3.29805 41.2779 1.59825 6.1243 20.9887 1.16769 +417 1 53.684 39.9214 3.65257 -36.1976 13.6917 8.19643 +418 2 52.3006 39.9493 4.06589 -56.8626 -17.5359 -10.0305 +419 2 52.042 40.5256 5.46425 9.62461 10.2848 -5.14962 +420 3 51.0331 41.2228 5.70144 14.4944 -11.372 -4.23176 +421 4 54.0189 39.0607 3.30247 15.8062 -40.5534 -6.95561 +422 4 51.6931 40.6476 3.38276 19.0563 -8.07776 7.22418 +423 2 51.5622 38.4976 3.96193 14.5706 2.1127 21.5154 +424 2 51.4158 37.9814 2.50572 24.752 -20.928 -15.9835 +425 2 51.0077 36.4305 2.37064 11.3099 30.9145 9.08043 +426 2 50.8522 35.9939 0.907307 -46.4939 -7.09254 -49.7464 +427 1 50.1475 34.7025 0.671588 69.6077 -32.405 2.84717 +428 4 50.6006 38.4842 4.55016 3.73478 6.81079 -18.2086 +429 4 52.1831 37.7463 4.55262 -3.81101 12.3643 -13.1539 +430 4 52.4118 38.1657 2.02278 1.77015 -18.5404 7.48984 +431 4 50.8584 38.5927 1.79489 -26.3581 9.74254 8.34414 +432 4 50.0453 36.2246 2.88499 -2.56193 3.57961 3.68626 +433 4 51.7703 35.8375 2.92238 0.215708 -6.73604 -5.33103 +434 4 51.7691 36.0437 0.240386 -6.2594 -4.10885 19.6388 +435 4 50.1039 36.686 0.3716 22.9763 1.60597 16.3794 +436 4 50.5914 33.8993 1.10828 2.95648 12.8391 18.7814 +437 4 50.3001 34.3737 41.6268 -19.3387 19.3411 -4.27099 +438 4 49.2006 34.6111 0.961468 -24.084 7.88088 -0.582308 +439 1 53.0235 40.2561 6.35237 -32.3128 10.4579 -5.0201 +440 2 53.1129 40.7256 7.70074 -41.6363 -1.15369 57.3167 +441 2 53.1798 0.352689 7.77253 -34.9991 -20.8035 37.2736 +442 3 52.5119 1.01286 8.63006 21.7579 -17.6925 -30.8538 +443 4 53.6931 39.5673 6.06584 22.7894 -18.2937 1.39271 +444 4 52.0865 40.4844 8.3065 35.7608 3.68212 -29.1988 +445 2 54.2701 40.0034 8.46069 6.08948 28.5921 -6.02695 +446 4 54.5971 40.5153 9.39975 -22.234 -14.34 10.1754 +447 4 0.201561 40.2092 7.93116 13.6903 -2.08726 -21.3806 +448 4 54.1655 38.8939 8.41526 -0.559105 0.118215 15.5404 +449 1 53.9752 0.884949 6.87383 32.3465 35.364 -24.1241 +450 2 54.062 2.35993 6.75215 -1.13821 -0.709889 -34.8218 +451 2 52.7471 3.02097 6.14186 4.92946 35.4069 59.7439 +452 3 52.3227 4.16587 6.4978 18.9545 -33.4145 3.00952 +453 4 54.7345 0.266534 6.4753 -18.8262 24.4346 -1.05702 +454 4 54.2802 2.76759 7.79054 -12.1814 3.84369 -14.3249 +455 2 0.185451 2.81859 5.73187 27.2059 46.9588 30.4236 +456 2 1.71808 2.36893 6.1571 -63.9259 -20.0653 -29.4315 +457 2 1.9764 2.63004 7.63437 43.6306 13.7343 2.97159 +458 2 3.27263 1.81187 8.04275 -33.9139 -3.58936 -6.58926 +459 1 3.78328 2.11956 9.34176 26.6398 21.4152 24.507 +460 4 0.173809 4.01773 5.82442 4.54198 -39.0295 -6.50933 +461 4 54.8792 2.64498 4.65574 11.0791 -10.5686 10.592 +462 4 2.43618 2.90609 5.45978 -2.35628 -10.1976 10.4282 +463 4 1.76796 1.2289 6.01344 4.57023 21.5888 -8.89179 +464 4 1.21473 2.41369 8.37281 -19.449 -19.8593 5.28327 +465 4 2.02309 3.72579 7.75906 18.9296 5.96095 -1.30777 +466 4 4.11389 1.88412 7.33652 2.51142 0.584915 -8.00636 +467 4 2.91513 0.727469 8.06593 14.1612 11.4678 0.952909 +468 4 3.87966 1.33238 9.93849 2.65093 -23.7146 9.43734 +469 4 3.29203 2.7681 9.89323 -42.3935 13.6729 9.41431 +470 4 4.65765 2.6209 9.4154 12.4458 -11.5538 -21.8273 +471 1 52.0387 2.32512 5.28273 -51.3661 -11.8477 -11.6622 +472 2 50.6641 2.72274 4.84157 25.7857 6.93126 13.1254 +473 2 49.5414 2.57609 5.91007 27.6149 -7.37739 5.45836 +474 3 48.7805 3.52104 6.09585 -8.9672 -1.93713 4.87304 +475 4 52.4681 1.55108 4.79165 6.19099 -18.5603 -5.58783 +476 4 50.6769 3.82983 4.70864 1.41274 -1.50214 -10.3294 +477 2 50.3587 2.05695 3.49156 -22.4167 -18.5545 -8.10533 +478 2 51.392 2.35646 2.3419 -24.5199 12.8001 2.40788 +479 2 48.9327 2.41504 2.97856 -9.14079 -2.86031 26.3031 +480 2 51.1945 1.4129 1.15651 29.522 -13.6455 -15.5517 +481 4 50.3189 0.937191 3.7523 9.08136 15.4094 -11.3523 +482 4 52.3823 2.12188 2.68097 31.5971 -0.36407 15.4796 +483 4 51.4014 3.46798 2.06765 -1.078 -19.9026 -0.0406259 +484 4 48.2117 2.12758 3.78451 -1.04241 22.2186 2.00084 +485 4 48.5813 1.67256 2.28636 2.21501 -12.0529 -35.8697 +486 4 48.7327 3.44552 2.54328 5.48386 -12.5705 11.3103 +487 4 52.1623 1.3706 0.452926 -36.5132 5.61179 20.4585 +488 4 50.2881 1.70969 0.600596 -1.11419 -0.409473 -10.6314 +489 4 51.0211 0.353877 1.53511 3.53067 13.7442 -8.50616 +490 1 49.5623 1.51743 6.77214 29.0905 -0.0770965 -25.5222 +491 2 48.7084 1.41716 7.91723 -3.12505 -21.6463 4.96918 +492 2 48.8549 2.61932 8.82546 31.903 20.2748 29.0475 +493 3 47.906 3.05048 9.46897 -16.8524 2.35798 -10.3438 +494 4 50.2118 0.710522 6.59294 -12.9921 18.0739 4.61122 +495 4 47.6425 1.393 7.52359 9.91609 0.328738 10.372 +496 2 49.0787 0.089334 8.73016 -60.0302 -9.6098 -44.8862 +497 2 48.2852 41.7441 10.0242 3.18066 15.7764 -9.96769 +498 2 46.7826 0.060746 9.96682 -2.34726 -14.6607 41.7592 +499 3 46.2233 0.511631 10.9878 -5.96974 4.10403 -23.4495 +500 1 46.1388 41.3329 8.97776 32.9533 20.065 15.0282 +501 4 50.1182 0.035639 8.93296 42.8084 2.68407 12.3764 +502 4 48.8904 41.1121 8.0025 3.88899 17.9501 19.4277 +503 4 48.6104 0.602172 10.7954 4.73737 -18.8132 -0.914642 +504 4 48.4759 40.6816 10.3394 0.165969 9.19265 10.3013 +505 4 46.673 40.8953 8.25882 14.2049 -15.3063 -26.5369 +506 4 45.1569 41.364 8.91958 -49.0994 -2.53611 0.320683 +507 1 50.1114 3.13932 9.06291 -28.12 32.8195 0.337886 +508 2 50.3404 4.32895 9.98795 -1.65029 -57.226 -17.8628 +509 2 50.0322 5.66893 9.41362 -36.2334 -9.83443 -38.9072 +510 3 49.3598 6.44562 10.1062 15.3309 6.40082 -5.38514 +511 4 50.9085 2.84633 8.5071 12.3092 -10.0263 -3.45928 +512 4 49.5835 4.28149 10.7848 -3.38143 -13.253 14.1405 +513 2 51.7461 4.22789 10.5468 25.7206 14.4209 20.1557 +514 2 51.9023 5.17188 11.7283 -67.9962 -1.36338 64.1829 +515 3 50.9364 5.19004 12.6002 28.9599 1.18541 -41.9912 +516 3 52.9319 5.83594 11.9785 18.8411 2.87417 -24.5577 +517 4 52.4276 4.5214 9.72474 12.6887 -3.13287 0.413374 +518 4 52.058 3.21563 10.9647 -9.24198 7.66389 -16.6414 +519 1 50.112 5.78532 8.03139 7.52033 29.602 25.459 +520 2 49.6799 7.08933 7.40639 14.3534 -30.8181 22.5674 +521 2 48.2409 7.17209 6.9711 -2.24553 44.7474 7.57528 +522 3 47.5844 8.22961 7.08968 18.1939 -9.81929 5.41459 +523 4 50.7064 5.09112 7.53173 -12.638 14.3936 -6.22521 +524 4 49.7159 7.84119 8.19837 -7.36252 7.51614 21.2329 +525 2 50.7023 7.64954 6.44039 -16.0213 -40.4967 -48.4302 +526 2 50.7257 6.82423 5.08423 -13.7427 47.9405 2.4816 +527 2 51.6418 7.28287 3.94021 29.8472 39.248 73.299 +528 2 53.127 6.98483 4.24688 1.29977 19.7271 -18.9866 +529 1 53.757 7.95176 5.17575 -11.1866 13.844 -62.5277 +530 4 51.636 7.68275 6.97838 28.3767 1.23741 1.58475 +531 4 50.4129 8.66535 6.18803 -0.179632 23.7408 -3.11047 +532 4 49.7187 7.01043 4.64523 -5.97611 -10.1095 1.48316 +533 4 50.8061 5.7562 5.2149 3.4405 -22.8364 10.0865 +534 4 51.5118 8.41472 3.72654 -1.36136 -26.6124 -3.74792 +535 4 51.4228 6.66542 3.12568 -20.7249 -22.8033 -58.4365 +536 4 53.6095 7.03345 3.2004 3.85152 5.93338 28.8514 +537 4 53.3314 5.96083 4.57939 -0.112253 -9.13532 8.29834 +538 4 53.309 8.86524 5.1699 0.162268 -2.42959 1.84412 +539 4 54.6672 8.17057 4.81193 19.2107 -0.812718 7.6593 +540 4 53.869 7.69009 6.11536 0.991087 -15.435 33.6166 +541 1 47.7293 6.1299 6.36528 -13.6545 -50.1986 -45.913 +542 2 46.4151 6.11998 5.73127 12.5517 -4.35851 26.1033 +543 2 45.4457 5.24236 6.50095 -54.5114 -4.35957 -22.3583 +544 3 44.2134 5.34166 6.22856 33.5613 3.36987 15.344 +545 4 48.2957 5.29705 6.08439 -4.65701 16.0313 11.2062 +546 4 46.0246 7.14829 5.83676 -12.413 4.85954 -1.2939 +547 2 46.3966 5.7006 4.23247 16.9743 -35.0719 19.3242 +548 2 46.8471 6.79722 3.31369 7.95245 13.9142 -51.9109 +549 2 46.0679 8.12855 3.29075 19.7668 12.2354 20.4517 +550 3 44.9703 8.28242 2.6836 -5.20426 -7.76074 -7.99938 +551 3 46.5716 9.08042 3.9624 -5.49585 -3.27174 -8.75295 +552 4 45.3525 5.37075 3.98324 7.30106 1.55378 -6.68576 +553 4 47.1483 4.79199 4.10624 -28.8106 21.423 0.303262 +554 4 47.0017 6.41037 2.24023 -12.0684 6.13088 18.9752 +555 4 47.8815 7.05675 3.60692 6.175 4.12296 2.89493 +556 1 45.8802 4.28795 7.34048 -32.7588 9.8199 -6.22093 +557 2 44.9801 3.41661 8.05582 7.11941 -0.762777 6.83491 +558 2 44.2841 2.32798 7.24802 57.2007 25.2815 -35.4523 +559 3 43.4338 1.62321 7.71908 -38.784 -24.7635 26.1598 +560 4 46.8556 4.13399 7.46211 34.7056 -9.13536 7.69054 +561 4 45.5867 2.90913 8.82837 -2.10841 -5.06197 5.41207 +562 4 44.2233 4.00883 8.63057 1.71074 -0.990438 -6.10924 +563 1 44.7516 2.08483 5.98824 -37.8462 -38.4135 -8.16449 +564 2 44.1597 1.01431 5.13579 -9.65639 -34.378 14.28 +565 2 44.8664 41.5016 5.49089 -11.1964 37.9598 3.64882 +566 3 46.103 41.4369 5.57345 -11.1149 2.47206 2.88353 +567 4 45.5262 2.474 5.47152 21.0389 22.2918 12.8005 +568 4 43.0172 0.862184 5.40503 31.5022 14.6416 -15.142 +569 2 44.4162 1.4085 3.60515 5.8653 -21.2021 14.2009 +570 2 43.5161 2.65984 3.27425 41.0117 -18.0627 24.5931 +571 2 44.2213 0.116838 2.67583 -30.001 3.65408 12.6342 +572 2 43.604 3.10049 1.82796 -41.0466 14.5447 22.3036 +573 4 45.4923 1.71966 3.57573 -0.138156 -3.02814 -11.6903 +574 4 43.8008 3.50537 3.97163 -2.46499 -4.10631 -11.566 +575 4 42.524 2.38704 3.60859 -29.3388 -0.685173 -5.23931 +576 4 44.5714 0.285197 1.65031 -2.2735 9.46305 -11.1841 +577 4 43.1006 41.7553 2.65834 21.2852 6.7215 -5.00379 +578 4 44.7366 41.0658 2.93547 0.768749 11.7185 9.28335 +579 4 44.5004 3.68719 1.60884 14.6444 -0.878149 -7.94907 +580 4 42.7371 3.8089 1.73084 7.8177 -0.664582 -10.9353 +581 4 43.3892 2.25631 1.16493 5.07933 -5.28874 -15.8541 +582 1 44.0858 40.4147 5.76991 -7.82686 10.7063 0.0613705 +583 2 44.6952 39.2248 6.26612 46.8291 -49.1328 2.55503 +584 2 45.6273 38.4983 5.15014 -10.8203 -24.5871 -10.3389 +585 3 45.1671 38.1033 4.04814 1.93862 22.6196 32.2907 +586 4 45.3114 39.4262 7.20071 -5.62912 7.00222 -16.0196 +587 2 43.5561 38.2867 6.74046 -22.632 -0.869913 -14.9675 +588 2 42.367 38.8131 5.80069 8.99216 14.1028 58.1483 +589 2 42.6345 40.3137 5.92605 0.476166 33.3948 28.8915 +590 4 43.357 38.4284 7.8368 -6.62566 13.9326 -12.0425 +591 4 43.8048 37.1922 6.7609 -3.60965 9.48681 -21.6917 +592 4 41.3136 38.6254 6.13023 8.266 -9.51845 1.65532 +593 4 42.4187 38.6156 4.74928 6.70678 -23.3061 -29.6074 +594 4 42.2773 40.816 6.98347 15.1971 -23.3227 -46.4987 +595 4 42.1119 40.8277 5.08767 -3.55372 4.4917 2.49103 +596 1 46.8487 37.9967 5.55394 17.2019 12.2692 25.006 +597 2 47.7247 37.0178 4.87762 -6.21972 -16.2302 -28.9734 +598 2 47.0354 35.8358 4.10675 -5.54108 30.4574 49.2069 +599 3 47.4638 35.4602 3.01706 -3.2731 6.26074 0.626287 +600 4 48.411 37.4477 4.12082 -11.0175 18.1135 -5.68521 +601 2 48.6499 36.5231 5.98749 -16.6595 -15.0747 15.7963 +602 2 48.891 37.7945 6.79307 0.637735 -25.9659 35.4869 +603 2 47.512 38.4108 6.81936 -6.06228 0.364124 -35.7901 +604 4 49.55 36.0027 5.64818 14.2665 0.926908 -8.4052 +605 4 48.1323 35.7432 6.6035 -1.04051 5.39171 0.916503 +606 4 49.6303 38.4539 6.33816 11.9938 9.28906 -4.17289 +607 4 49.2156 37.5316 7.87598 -0.828426 8.45001 -24.626 +608 4 47.6223 39.5002 6.92189 -5.61966 10.135 -2.25063 +609 4 46.9349 38.0418 7.65693 -11.0214 -6.34351 22.8142 +610 1 45.9811 35.3016 4.79343 19.1712 31.3513 11.165 +611 2 45.3118 34.1769 4.28537 -21.2148 -46.3229 -17.5718 +612 2 44.4751 34.4561 3.06273 -18.3812 8.00009 -33.6438 +613 3 44.391 33.6426 2.09905 3.94034 16.0457 30.0851 +614 4 45.6176 35.6832 5.71813 13.2063 -8.66839 -22.6288 +615 4 46.0373 33.4799 3.80083 11.0255 -0.404913 12.3267 +616 2 44.604 33.4055 5.40679 37.9095 -5.49339 -20.8443 +617 2 43.894 32.1911 4.95963 4.52806 -52.0805 -10.2655 +618 3 42.6666 32.0496 5.30411 26.1406 -7.63566 -17.5185 +619 3 44.6473 31.2926 4.419 -30.7677 19.4747 14.2469 +620 4 43.8381 33.9821 5.82617 -35.1808 40.951 30.2942 +621 4 45.3664 33.1691 6.19311 -10.275 -1.0365 4.4818 +622 1 43.9409 35.7078 2.94042 3.22733 -51.5357 -49.9186 +623 2 43.348 36.2006 1.70588 25.8776 -9.12573 -18.8138 +624 2 44.3757 36.8172 0.713167 -7.64912 -13.2689 38.6134 +625 3 44.0628 36.9589 41.4508 -2.41529 3.02373 -15.0868 +626 4 43.9087 36.323 3.69682 4.46748 41.5024 48.5675 +627 4 43.0059 35.3045 1.0879 -7.34341 13.0696 15.3539 +628 2 42.2218 37.2049 1.98307 -32.8685 -0.904888 11.5727 +629 2 41.1062 36.5938 2.90711 22.5622 20.6064 -2.77479 +630 2 39.8757 37.4913 2.92488 9.99264 -5.47282 62.3883 +631 3 39.5847 37.9927 4.02645 -6.88693 1.84466 -13.34 +632 1 39.0832 37.5519 1.86835 -2.09978 -20.426 -31.5908 +633 4 41.7044 37.4782 1.02484 10.2081 4.13789 1.30545 +634 4 42.5649 38.1527 2.49808 3.34998 -7.04672 -12.996 +635 4 41.496 36.4873 3.97615 -8.32458 2.86238 -16.0656 +636 4 40.817 35.592 2.59085 -6.50381 -15.3028 -7.15704 +637 4 39.3467 37.1489 0.943045 -1.18671 2.30285 11.2704 +638 4 38.1024 37.7997 2.00291 -4.61511 13.1634 -1.5169 +639 1 45.5865 37.1913 1.18701 0.34656 3.48246 -50.9957 +640 2 46.5715 37.7193 0.263736 40.0587 13.4866 27.3297 +641 2 47.1476 36.6709 41.2495 -9.99518 -39.8037 -22.9547 +642 3 47.6611 35.6473 41.7682 -3.12622 19.3551 -24.5438 +643 4 45.9505 37.0475 2.10099 0.0710674 -6.02767 36.3056 +644 4 46.0766 38.4733 41.5789 -9.05589 19.6465 -18.4972 +645 2 47.8462 38.4064 1.04164 -24.5048 14.2529 -26.5929 +646 2 47.4036 39.6651 1.82888 -3.7708 6.53308 31.1421 +647 2 48.5926 40.4064 2.51341 13.2626 3.99863 -2.76696 +648 3 49.7104 40.5691 1.98441 -24.6046 -10.5895 -1.86534 +649 1 48.3407 40.8898 3.74779 29.4138 -3.81739 16.8938 +650 4 48.597 38.7482 0.246377 -8.81496 -5.86425 14.2737 +651 4 48.3893 37.7509 1.72975 1.66752 -15.4435 3.74234 +652 4 46.6019 39.4971 2.66308 23.3117 -7.11271 -27.0857 +653 4 46.9261 40.3559 1.12913 -3.21242 13.4997 -7.95635 +654 4 47.3907 40.9351 4.12169 -5.60594 2.69026 7.41827 +655 4 49.1659 41.1473 4.37984 -25.8317 -2.18268 -20.985 +656 1 47.0143 36.8241 39.8589 2.94896 -6.17569 33.9376 +657 2 47.6738 36.0506 38.8108 16.6825 -23.5637 34.6067 +658 2 48.454 37.0258 37.9695 9.24498 -19.2444 17.2828 +659 3 47.9734 37.5867 37.0249 -16.9661 22.5794 -32.933 +660 4 46.3407 37.4883 39.4677 -2.13376 9.43233 0.449621 +661 4 48.4374 35.3321 39.3605 -24.6855 17.1776 -23.0678 +662 2 46.6968 35.2528 37.909 -27.9143 -33.2437 25.7199 +663 2 46.039 33.9895 38.7043 9.93401 10.5983 7.56799 +664 2 46.87 32.6784 38.9289 23.0786 -0.450758 -24.5995 +665 1 47.7656 32.5928 40.0651 -0.0346617 67.7235 50.2506 +666 2 48.5337 31.5574 40.3699 -14.5633 -26.8579 -35.9878 +667 1 48.7282 30.552 39.4879 -2.05986 8.25564 18.106 +668 1 48.8872 31.3858 41.6213 -4.84512 27.348 -3.11289 +669 4 47.2327 34.8627 37.0058 -5.81127 5.13112 -1.60937 +670 4 45.8267 35.9464 37.6192 18.3744 -10.9215 -5.83414 +671 4 45.065 33.6697 38.178 15.3305 12.1509 10.6411 +672 4 45.8045 34.3704 39.7428 -14.1926 -3.74807 -10.9265 +673 4 47.5159 32.4832 38.0006 -21.4463 1.51143 8.96621 +674 4 46.1858 31.8178 39.0967 -9.12823 -0.449275 -15.1225 +675 4 47.7485 33.3794 40.8208 -8.02877 -26.8637 -33.9869 +676 4 48.3609 30.5297 38.5261 -2.43008 2.66571 1.08755 +677 4 49.1746 29.6933 39.8011 5.57148 -11.3344 1.43527 +678 4 48.5595 32.0107 0.447997 -4.49593 6.14729 8.57279 +679 4 49.3675 30.5632 41.8859 20.5825 -37.41 17.1512 +680 1 49.6971 37.2567 38.3612 38.8031 36.8466 -19.9315 +681 2 50.6251 38.1764 37.6375 5.59701 -6.58181 11.8605 +682 2 51.1059 37.476 36.33 -5.39593 -3.52342 3.95062 +683 3 51.4567 36.2851 36.3473 -6.1727 9.88097 2.62067 +684 4 50.1666 36.6257 38.9842 10.5469 -17.0261 18.2142 +685 4 50.0436 39.1015 37.4003 1.48542 -2.85918 -9.88003 +686 2 51.8783 38.6033 38.5414 -14.1699 17.2606 4.5582 +687 2 51.4771 39.4948 39.8067 23.634 -8.13025 9.13717 +688 2 52.8025 39.6936 40.6861 -45.72 0.0787629 30.9804 +689 2 51.0312 40.8873 39.3543 -1.21924 6.71403 17.5275 +690 4 52.6247 39.2003 37.9187 -12.0326 -10.2321 5.24388 +691 4 52.4336 37.7304 38.9418 -1.83231 -8.6555 -7.07863 +692 4 50.6844 38.9864 40.4458 6.67436 6.37453 -9.78056 +693 4 52.9275 38.7652 41.2899 1.57503 4.15297 5.5095 +694 4 52.875 40.6185 41.4124 -9.95772 -27.9304 -22.9777 +695 4 53.6477 39.6981 40.0479 39.2622 9.27083 -23.1198 +696 4 51.882 41.4315 38.8764 -8.78739 -1.58992 -12.4168 +697 4 50.8284 41.5065 40.2813 -10.0843 -5.65437 -12.2377 +698 4 50.1041 40.7893 38.7156 9.84678 12.7352 4.22225 +699 1 51.1335 38.2092 35.1872 23.4477 43.7196 -18.1994 +700 2 51.5372 37.7272 33.8205 5.66277 23.826 53.2621 +701 2 52.816 38.5373 33.39 -13.9696 27.2523 3.91394 +702 3 52.9014 39.7954 33.5824 -9.48934 -35.8428 -1.88315 +703 4 51.0917 39.2914 35.1751 -6.07189 -44.7564 8.7296 +704 4 51.807 36.6734 33.9114 3.67702 -17.8942 -3.77347 +705 2 50.2728 37.942 32.9627 24.5619 2.20768 -27.072 +706 2 49.0946 37.0552 33.3907 -40.4332 32.861 4.12747 +707 2 50.6582 37.6771 31.4819 -4.87136 -12.6088 -15.1928 +708 2 49.1924 35.592 33.2496 18.605 -47.1891 -10.6734 +709 4 50.0222 39.0181 33.0462 -10.0421 3.96713 0.824793 +710 4 48.1822 37.369 32.7965 11.3859 0.507389 5.43773 +711 4 48.766 37.227 34.4352 6.35082 10.8857 5.72377 +712 4 49.7261 37.457 30.8365 21.3715 9.42576 10.5226 +713 4 51.3528 36.7896 31.3856 -11.4398 6.26312 1.5823 +714 4 51.2274 38.5516 31.0485 -10.0605 -6.0953 1.35419 +715 4 50.1827 35.2313 33.6939 -19.2762 -1.86106 -7.31237 +716 4 49.1345 35.3223 32.1629 6.46074 -3.78635 4.92713 +717 4 48.3248 35.0641 33.7333 8.66481 1.90115 0.669024 +718 1 53.7674 37.8522 32.7049 -0.401058 29.0536 2.76503 +719 2 54.8534 38.494 31.9889 21.3589 25.2573 -50.7784 +720 2 0.070256 37.9331 30.5159 -12.6617 -10.513 26.1463 +721 3 0.610536 36.8336 30.3273 -13.153 9.14635 -3.0322 +722 4 53.7049 36.8532 32.6778 5.78014 -33.2974 -6.55066 +723 4 54.4976 39.583 31.7137 12.734 -24.0185 30.659 +724 2 1.32523 38.4582 32.6174 -11.2306 -14.0383 43.8112 +725 2 2.25298 39.4244 31.93 21.239 -3.52493 -6.53852 +726 2 1.82142 40.7594 31.946 9.01925 8.15494 1.3639 +727 2 3.55305 39.1373 31.3858 -52.1121 -37.4601 32.7366 +728 2 2.62719 41.7738 31.436 16.1375 42.966 -9.20235 +729 2 4.2717 40.1621 30.8907 55.019 31.5071 -38.7093 +730 2 3.8753 41.5182 30.8618 10.3374 -30.1635 6.5347 +731 4 1.72137 37.3957 32.6071 -2.968 13.2806 -7.3675 +732 4 1.36361 38.7573 33.7485 -10.0277 -6.08615 -32.1159 +733 4 0.900203 41.04 32.4671 -4.90014 4.47018 0.827909 +734 4 4.05865 38.1292 31.3848 -19.507 10.3261 2.47632 +735 4 2.40669 0.963664 31.507 -12.4107 -17.8541 2.52862 +736 4 5.22734 39.8163 30.4261 -2.17835 18.3508 4.41679 +737 4 4.61313 0.382875 30.4956 -18.9116 -9.53382 4.9162 +738 1 54.5208 38.7001 29.536 -17.794 9.59417 2.44526 +739 2 54.4433 38.3677 28.0932 0.413701 6.77287 11.8816 +740 2 53.8236 36.9714 27.8054 -10.5704 38.9519 24.3324 +741 3 54.2836 36.1684 27.0139 12.3723 -16.7122 -9.38408 +742 4 54.0063 39.582 29.8758 15.9225 -27.1932 -25.0825 +743 4 53.6617 39.0994 27.7122 21.1252 -9.31914 -10.5745 +744 2 0.84771 38.4562 27.3872 5.21129 26.4327 0.415045 +745 4 1.55752 39.2926 27.6564 -22.375 -0.429945 3.27523 +746 4 0.737328 38.5366 26.268 -0.662808 -7.52676 8.67249 +747 4 1.44048 37.5755 27.6711 3.3074 -14.1434 -6.0421 +748 1 52.6712 36.7812 28.4639 -34.4859 10.4254 42.9936 +749 2 51.8461 35.5981 28.5315 7.11639 -32.3641 19.2856 +750 2 52.1287 34.6607 29.761 72.1729 37.4894 -16.6197 +751 3 51.2969 33.8912 30.1393 -37.38 -39.1809 16.7772 +752 4 52.2301 37.5459 29.0797 18.7619 -22.9106 -24.882 +753 4 50.752 35.8045 28.6381 6.6344 10.4547 -3.03351 +754 4 51.9318 34.9661 27.6028 3.27123 7.03186 8.45077 +755 1 53.4041 34.6064 30.3039 -37.1524 -18.2668 23.7743 +756 2 53.8481 33.579 31.3343 19.9058 12.4048 -28.9308 +757 2 53.2753 33.7631 32.7245 -4.20442 17.2631 -10.7202 +758 3 53.3264 34.8931 33.2388 -7.00143 -11.8952 2.65621 +759 4 53.9984 35.4233 30.2821 14.046 11.4873 -9.55867 +760 4 53.5575 32.5679 30.9796 -2.97426 -3.20006 -4.3618 +761 2 0.441949 33.6673 31.397 15.483 24.485 -22.5221 +762 2 1.1159 33.1056 30.111 -2.52249 -22.0361 -11.2405 +763 2 2.65939 33.3504 30.0471 -29.7948 -11.8394 -36.8606 +764 2 3.5253 32.433 30.8659 3.71436 3.74322 35.9681 +765 1 4.92891 32.7835 30.8601 -3.73949 -14.6782 3.94495 +766 4 0.930008 33.1164 32.2052 -10.1795 -8.12889 21.2637 +767 4 0.820281 34.7554 31.5264 -17.1946 -20.5931 1.67355 +768 4 0.726808 33.5631 29.1693 -8.69229 5.5421 6.41341 +769 4 0.816642 32.0044 30.0112 14.0154 14.8269 0.94841 +770 4 2.76655 34.4177 30.2798 16.9839 11.3836 1.64388 +771 4 2.99027 33.2006 28.9712 -4.31169 8.16855 10.4317 +772 4 3.48024 31.3628 30.6286 -9.21502 -9.13385 -9.88849 +773 4 3.14214 32.5157 31.9169 10.307 -3.37241 -3.01155 +774 4 5.38024 32.7641 29.968 4.13535 -6.65161 -12.8027 +775 4 5.44585 32.16 31.4735 7.57437 4.94374 1.68638 +776 4 5.11721 33.7072 31.1652 -0.520286 24.3887 13.7994 +777 1 52.7286 32.6609 33.3217 21.3895 7.82715 -40.48 +778 2 52.3746 32.6765 34.6845 -3.94215 -5.7204 42.1903 +779 2 53.6544 32.9612 35.4718 -32.0777 16.7216 -3.31611 +780 3 54.7101 32.4293 35.2196 26.5529 -12.799 -1.69002 +781 4 52.7346 31.7402 32.8358 -3.66087 10.5856 2.03104 +782 4 51.6553 33.4893 34.886 -4.93781 11.2662 -7.45083 +783 2 51.7389 31.3462 35.1425 36.1525 -8.24878 -2.45066 +784 2 50.4549 31.4357 35.902 -2.56298 9.46411 57.003 +785 2 50.5914 31.9702 37.3969 -4.77582 -10.2539 -35.2763 +786 3 49.9129 32.941 37.7385 4.53321 10.1718 7.36032 +787 1 51.4448 31.3274 38.2318 1.89331 10.2207 20.9211 +788 4 52.4532 30.7011 35.7138 0.934865 4.72627 -2.3237 +789 4 51.5619 30.7887 34.2312 -11.1921 -21.1455 -14.7508 +790 4 50.0197 30.4197 36.0127 -8.03636 -0.273264 -6.56567 +791 4 49.7685 32.1089 35.3545 -11.9583 -2.57651 0.31815 +792 4 51.7323 30.3416 38.1022 2.22495 5.18328 -8.30147 +793 4 51.645 31.7871 39.1631 -4.2657 -12.8631 -21.1898 +794 1 53.54 33.8952 36.4131 -39.2018 -0.531466 -0.79929 +795 2 54.5682 34.2648 37.3102 -29.3437 58.7358 21.9421 +796 2 54.3255 33.5954 38.6431 29.6978 -77.406 0.637438 +797 3 53.3742 33.7807 39.3881 -15.8118 22.9548 5.85491 +798 4 52.6165 34.3686 36.5483 14.9252 -1.63515 2.31459 +799 4 0.525104 33.9954 36.8979 32.3496 -27.0675 -4.05845 +800 2 54.6285 35.827 37.4074 -17.7645 -17.3983 39.0191 +801 2 0.013954 36.4546 36.058 15.6745 -1.04323 18.583 +802 2 0.049019 37.9526 36.293 -63.1087 6.90888 -39.4544 +803 2 1.42802 35.9308 35.6826 4.08802 -6.56861 34.108 +804 4 0.435555 35.9801 38.2063 -13.4425 16.5914 -13.2273 +805 4 53.6198 36.2963 37.798 28.292 -21.2068 -7.80607 +806 4 54.2061 36.2134 35.3084 7.36084 -1.04605 -3.46995 +807 4 54.0713 38.2397 36.8522 27.1057 4.55429 -9.55418 +808 4 54.939 38.4282 35.2643 6.0019 1.58695 18.2366 +809 4 0.927863 38.3313 36.762 28.685 14.2218 21.5028 +810 4 1.30489 34.8989 35.3991 1.43296 -22.664 -21.4406 +811 4 2.25694 35.8344 36.4845 -24.5016 17.8738 -12.6534 +812 4 1.83634 36.4362 34.8335 13.635 15.7788 -26.8996 +813 1 0.008587 32.3758 38.733 13.7846 27.3237 -75.0314 +814 2 54.826 31.3 39.6331 17.4428 -14.6066 45.4768 +815 2 0.455793 31.7866 40.9725 -5.37526 1.66294 14.9859 +816 3 1.60943 32.1773 41.0547 11.2247 3.92934 -7.13086 +817 4 0.661532 32.0877 37.9163 -19.8505 19.9989 33.4434 +818 4 53.7452 31.1425 39.875 0.374502 -5.35979 -15.722 +819 2 0.574437 30.0043 39.0439 11.2157 23.6116 11.9724 +820 2 0.334302 28.7136 39.8578 -22.6665 -11.1233 -21.4622 +821 2 0.695999 28.7 41.3625 12.0844 -36.9796 9.0265 +822 3 54.7253 28.727 0.298109 10.889 15.3071 -4.11946 +823 3 1.91063 28.4506 41.7261 -30.7481 15.8042 -10.4483 +824 4 1.71086 30.1341 39.082 -19.7243 9.32222 0.312381 +825 4 0.358791 29.9926 37.9166 -2.62684 -19.8589 21.79 +826 4 0.882365 27.912 39.2891 -0.232785 0.308618 14.1734 +827 4 54.2301 28.3798 39.7718 17.2545 10.1943 -0.206185 +828 1 54.6325 31.7916 0.156881 38.5875 2.07504 -29.8841 +829 2 54.8631 32.3302 1.45975 7.41407 33.4343 26.7616 +830 2 1.21087 32.0241 2.20189 -33.1211 2.89979 -4.9396 +831 3 1.57835 32.811 3.08735 12.0797 -3.2377 -11.0832 +832 4 53.6756 31.6317 41.8616 -38.5912 -7.03962 0.740029 +833 4 54.9627 33.4927 1.3754 -11.7864 -35.033 -4.32612 +834 2 53.6666 32.0355 2.42828 -17.6969 8.95863 -1.18459 +835 2 52.1933 32.3158 2.0402 15.1012 41.0915 -15.9482 +836 3 51.3911 33.0513 2.74715 36.5037 -34.5123 -13.5772 +837 3 51.9207 32.0348 0.835441 -22.1157 -3.97518 6.29873 +838 4 53.9089 32.5595 3.33158 -2.01457 20.6007 30.7692 +839 4 53.6609 31.0051 2.75768 6.68313 -26.6133 3.27231 +840 1 1.77413 30.8239 1.99288 23.346 -11.0551 12.4557 +841 2 2.99412 30.3649 2.70859 20.7873 20.7026 2.58588 +842 2 4.37767 30.5585 1.9432 -4.58172 12.4342 76.2013 +843 3 5.43315 30.6356 2.6242 -17.4542 -1.84538 -14.1099 +844 4 1.23141 30.1158 1.49013 8.16278 -4.42375 -5.05013 +845 4 3.08709 30.9756 3.71749 -2.54673 -19.312 -31.0286 +846 4 2.99418 29.2776 2.99437 -11.6108 14.2547 -3.21828 +847 1 4.33484 30.73 0.643592 -44.4777 10.1896 -41.2897 +848 2 5.29878 31.2923 41.6537 25.3276 0.744315 3.96016 +849 2 5.54544 32.7486 0.121481 37.2819 -30.872 -27.7426 +850 3 4.68176 33.387 0.67546 -18.5336 28.2868 17.8008 +851 4 3.3891 30.7154 0.224796 5.58966 -1.49205 -0.51948 +852 4 6.30256 30.8588 41.8823 -3.47112 -15.4387 -8.82901 +853 2 4.8423 31.1802 40.1578 47.5835 -21.6785 -9.15502 +854 2 4.71332 29.7742 39.4637 -7.18766 34.2596 -8.85866 +855 2 5.63064 28.6968 40.0034 1.34917 -52.5839 -25.1875 +856 1 5.28494 28.1736 41.3081 -3.70672 3.58414 23.7744 +857 2 6.07557 28.0057 0.492928 -10.4577 4.69864 -29.3733 +858 1 7.37832 28.2278 0.392183 22.9004 -4.79637 26.256 +859 1 5.53705 27.6868 1.66636 -6.4094 -24.443 39.9026 +860 4 5.53303 31.787 39.5095 -0.196101 -2.7377 7.98036 +861 4 3.92152 31.7024 40.0755 -40.4143 20.5365 -6.7059 +862 4 4.89215 29.8961 38.3273 -2.53464 -0.592337 23.8175 +863 4 3.64677 29.4833 39.5295 -2.27017 -8.63927 2.61329 +864 4 6.69627 28.939 39.9328 9.42975 10.3347 -2.35439 +865 4 5.48992 27.7969 39.2806 7.04825 21.6687 20.0754 +866 4 4.27254 28.0467 41.4152 -4.83075 -3.28587 3.65899 +867 4 7.98538 28.2099 41.4852 -8.02405 3.18538 -21.0185 +868 4 7.94047 28.2423 1.24565 0.364194 -0.98827 11.7246 +869 4 4.53186 27.4078 1.78766 14.7644 10.3007 -8.4097 +870 4 6.1013 27.52 2.55737 -8.44391 7.70178 -27.0297 +871 1 6.79596 33.2006 41.6804 -27.9344 8.59735 4.57792 +872 2 7.15148 34.5952 41.8655 -38.9276 -12.1291 -1.68573 +873 2 6.77215 35.2911 40.5652 14.0197 56.9428 51.8707 +874 3 6.49158 34.715 39.5569 -13.5951 -21.5425 -43.0675 +875 4 7.31858 32.7386 40.9072 -2.655 4.76346 14.1821 +876 4 6.52583 35.0505 0.829338 19.3934 -10.3795 -24.0216 +877 2 8.63545 34.7883 0.159249 -4.7809 22.3707 74.7553 +878 3 9.31911 34.1951 41.0459 32.4158 -10.9375 -20.7672 +879 2 9.12239 34.1481 1.54228 -45.3508 12.3646 -39.5443 +880 4 8.86138 35.9031 0.177513 1.59938 -13.4643 1.18346 +881 4 10.1943 34.4871 41.2598 15.0836 -7.29109 -20.5697 +882 4 10.1218 34.4779 1.7295 32.9793 8.82002 13.7556 +883 4 9.1354 33.0404 1.45915 -3.89828 -1.77159 7.54964 +884 4 8.44695 34.5279 2.36236 9.39315 -9.78399 0.0431608 +885 1 6.96309 36.6454 40.6555 -22.2962 -38.3404 -33.8498 +886 2 6.94214 37.5275 39.5132 -15.3576 22.9899 27.1878 +887 2 8.03225 37.1821 38.5547 25.8315 2.87875 -39.3086 +888 3 7.87409 37.2091 37.3037 -11.7489 -2.94068 30.2829 +889 4 7.09017 37.0079 41.5812 4.58243 22.402 24.7274 +890 4 6.01646 37.4072 38.9238 -6.0018 -8.28766 -1.15408 +891 2 7.01182 39.0163 40.0252 -15.3603 -23.3284 55.3652 +892 2 5.61926 39.5384 40.7634 13.0639 11.727 -14.3013 +893 2 5.74741 41.0778 41.0735 34.612 -8.65688 -61.1535 +894 2 4.30485 39.278 39.9775 33.2171 6.29002 -24.4772 +895 4 7.23253 39.6079 39.1676 9.01238 29.648 -28.6912 +896 4 7.91826 39.1206 40.7867 -28.368 0.120823 -25.2036 +897 4 5.4532 38.9933 41.7239 13.5286 -1.18368 4.70417 +898 4 4.88701 41.4539 41.5866 -22.2749 9.39049 21.0562 +899 4 5.89633 41.7578 40.1185 -8.19165 -26.548 25.276 +900 4 6.67066 41.2365 41.6556 -0.494064 4.57358 11.7906 +901 4 4.18164 39.8273 38.9933 8.48456 -7.17755 11.4037 +902 4 3.44244 39.5261 40.5797 -17.807 1.17877 7.97341 +903 4 4.2824 38.1939 39.7929 -10.4691 -3.8299 -8.01616 +904 1 9.23783 36.8543 39.0653 -4.40645 21.0053 19.4908 +905 2 10.3275 36.5838 38.1582 31.0816 -25.3995 62.8998 +906 2 10.2997 35.2224 37.4613 6.04581 38.1949 -0.210763 +907 3 11.0208 35.1071 36.4655 -6.3656 -14.3958 -11.0193 +908 4 9.51333 37.1441 40.0706 -14.9717 -14.5173 -38.8343 +909 4 10.386 37.3498 37.3821 -1.67567 12.3369 -13.0834 +910 2 11.6168 36.6846 39.0604 -5.3878 -32.5356 -23.0633 +911 3 11.6818 35.7254 40.0985 -18.2206 13.507 16.8431 +912 4 11.7318 37.6647 39.5052 6.99822 20.9023 2.76215 +913 4 12.4798 36.426 38.4299 12.1644 16.7594 -11.1747 +914 4 12.2479 35.0511 39.7675 10.0745 -20.8981 -3.76732 +915 1 9.3909 34.3264 37.8733 -42.427 -15.3638 26.6935 +916 2 8.99216 33.1557 37.0842 54.1918 17.4661 1.85655 +917 2 8.44195 33.5842 35.7305 -20.833 60.571 55.2199 +918 3 8.45395 32.8337 34.8033 7.91235 -41.3122 -40.5547 +919 4 8.901 34.4208 38.8182 18.72 -3.57692 -25.7233 +920 4 10.0039 32.69 36.8915 -15.1884 -12.4868 -9.34361 +921 2 8.05349 32.1507 37.7268 -1.844 -26.1592 7.76215 +922 2 8.63612 31.2276 38.7905 8.98886 15.2457 3.52798 +923 3 8.28567 31.4376 39.9878 9.18033 -14.5703 -9.08999 +924 3 9.46172 30.3301 38.4185 -14.4281 10.7169 -2.66077 +925 4 7.57008 31.4717 36.9797 -4.32683 11.3708 2.99534 +926 4 7.24557 32.7088 38.1955 -18.7592 7.98312 4.87833 +927 1 7.76821 34.7903 35.7104 -0.921577 -49.5867 -7.77983 +928 2 7.00589 35.2713 34.5947 28.4194 33.7396 -49.4054 +929 2 7.85162 36.3274 33.7967 14.0615 10.3677 50.876 +930 3 7.59561 36.677 32.642 -11.5138 -12.0529 -0.0837023 +931 4 7.64044 35.3156 36.5601 -2.79577 12.0246 16.4277 +932 4 6.95142 34.464 33.8059 -8.74679 1.13416 10.6726 +933 2 5.60472 35.8897 34.9384 -10.82 -34.5279 -29.2679 +934 2 4.80808 34.6511 35.4252 21.4048 19.1212 -24.4535 +935 2 4.58939 34.449 36.7896 -8.79739 7.49237 6.99756 +936 2 4.44707 33.6361 34.4808 -22.1156 13.6667 13.0483 +937 2 3.78406 33.375 37.155 10.056 16.8174 60.0349 +938 2 3.57928 32.5992 34.8543 35.6828 20.067 14.4288 +939 2 3.32606 32.5122 36.2195 -36.4887 -32.5961 -12.2866 +940 3 2.43989 31.6229 36.7148 -5.7594 -17.052 -20.0699 +941 4 5.14192 36.3424 33.9886 5.39246 -18.3577 14.2305 +942 4 5.60606 36.7583 35.5989 7.01287 1.52307 19.367 +943 4 4.94491 35.1783 37.5598 -4.47364 -7.92921 -7.91861 +944 4 4.66046 33.7427 33.4202 4.87397 4.4658 -8.40916 +945 4 3.45738 33.1597 38.2449 15.2806 17.1295 -26.8514 +946 4 3.26795 31.828 34.148 -6.61111 -3.61155 -4.72788 +947 4 2.1868 31.1622 35.9134 -6.91994 -9.03483 11.406 +948 1 8.90205 36.8981 34.5027 -17.2687 17.5401 -60.9896 +949 2 9.70361 38.0134 33.9387 24.2231 -52.0812 37.3823 +950 2 8.8546 39.1711 33.5701 14.7092 18.0593 -4.53516 +951 3 9.06515 39.7643 32.526 6.45085 3.58457 -7.26619 +952 4 9.11675 36.6435 35.4518 3.62665 -3.0608 21.1339 +953 4 10.3861 38.3235 34.818 -10.2978 3.44266 -21.7419 +954 2 10.5787 37.5562 32.7307 -21.6135 -30.8037 4.74181 +955 2 11.6892 38.5091 32.4223 15.379 -13.1594 38.9153 +956 3 11.683 39.1804 31.4042 4.19267 20.0472 -18.4805 +957 1 12.6852 38.53 33.3751 41.3863 26.0224 -13.8263 +958 4 9.85905 37.4261 31.8504 20.0453 2.40541 7.8736 +959 4 11.053 36.5467 32.9319 -7.17885 8.97611 -4.2567 +960 4 12.817 37.8369 34.166 -15.4043 12.1891 -16.4176 +961 4 13.5001 39.2408 33.2564 -39.0039 -25.8302 4.81098 +962 1 7.96197 39.5631 34.4599 -33.9246 23.5433 37.1278 +963 2 7.21007 40.8276 34.5568 -18.3646 -15.2096 -14.7898 +964 2 8.22007 41.896 34.9201 0.758716 14.3361 -6.26955 +965 3 8.97663 41.7874 35.871 13.0919 -8.40756 13.8683 +966 4 7.83943 39.0508 35.3409 8.95409 -9.59767 0.690263 +967 4 6.70734 41.0591 33.5261 17.9743 -2.28149 22.8597 +968 2 6.0301 40.6247 35.6674 21.3841 11.5647 -11.8815 +969 2 4.89974 39.9794 34.8247 17.8968 2.41192 -27.2216 +970 2 5.64567 41.9074 36.4174 -5.31946 16.9228 -22.0167 +971 2 3.85064 39.271 35.6143 -7.9417 -14.8054 48.1955 +972 4 6.41951 40.0018 36.4929 2.02391 -20.04 -2.41117 +973 4 5.36435 39.2019 34.126 -8.73918 7.93575 11.5905 +974 4 4.48342 40.7424 34.1094 -6.00744 -5.42447 8.5897 +975 4 5.00487 41.8434 37.3074 -11.5574 -14.3762 1.01334 +976 4 5.12929 0.689353 35.6946 7.17582 1.37977 8.89479 +977 4 6.56067 0.460605 36.8355 2.18467 8.54142 -3.2903 +978 4 3.23423 39.9796 36.2601 8.91814 -10.815 -11.4927 +979 4 4.38489 38.5352 36.333 -17.3309 14.265 -14.1697 +980 4 3.16246 38.6765 34.9814 -1.3822 0.0882741 -1.23744 +981 1 8.27901 1.09677 34.1745 -17.8694 -35.8502 15.8719 +982 2 9.1495 2.17731 34.4611 25.5007 24.1899 -15.5427 +983 2 8.44305 3.45517 34.8181 7.33507 13.3767 -14.0082 +984 3 7.22584 3.58853 34.5952 14.73 6.44535 13.4701 +985 4 7.64387 1.07834 33.3925 -5.10967 17.8437 -25.4682 +986 4 9.72616 1.98981 35.3795 6.67437 -11.367 8.50474 +987 2 10.1416 2.3939 33.2727 7.80857 1.28792 -5.65283 +988 2 11.1754 1.27875 33.0535 -29.5709 -1.62172 8.74553 +989 2 12.298 1.25902 34.0434 45.8123 -20.4226 -15.8942 +990 3 13.4264 1.60062 33.6211 -9.09849 2.20405 14.6225 +991 1 12.1286 0.499484 35.1615 13.5856 38.0862 1.93866 +992 4 10.7117 3.33658 33.4062 0.0269402 1.80508 0.780117 +993 4 9.62868 2.54332 32.3022 -11.3844 1.67988 3.84081 +994 4 11.6026 1.39089 32.0291 1.1132 -6.32648 1.88738 +995 4 10.6463 0.304077 33.1517 4.80745 -4.48978 -13.057 +996 4 11.1623 0.324257 35.4356 -7.1112 -9.24345 12.7946 +997 4 12.86 0.645961 35.8984 -11.3978 -13.87 -11.7385 +998 1 9.29061 4.442 35.2624 -22.3208 40.9019 24.8252 +999 2 8.81116 5.82611 35.6978 -18.3987 -9.60009 -41.1421 +1000 2 7.90959 6.36535 34.5148 35.1086 -14.4229 -13.6713 +1001 3 8.27789 6.14754 33.3333 -13.6173 9.04219 21.6414 +1002 4 10.326 4.35425 35.3433 -15.5473 -10.8229 -5.10085 +1003 4 8.07437 5.70026 36.5174 9.02025 -1.47766 10.124 +1004 2 9.99583 6.76313 36.1565 -25.1565 20.6308 -28.9867 +1005 2 11.135 6.93617 35.1361 2.62363 -10.5046 6.46017 +1006 2 12.4502 7.42969 35.8581 -25.4448 -27.2564 -27.4451 +1007 2 12.3858 8.85842 36.3442 -55.084 26.5775 24.6628 +1008 1 13.634 9.41318 36.7712 33.8844 -44.8334 11.878 +1009 4 10.2929 6.30703 37.0832 24.0012 -1.96783 25.2264 +1010 4 9.73373 7.84957 36.4159 -14.1304 -26.7275 0.147522 +1011 4 10.8081 7.68154 34.3572 5.16283 -4.02502 4.78839 +1012 4 11.298 5.9636 34.5725 5.23915 16.0099 8.41141 +1013 4 13.159 7.4137 35.035 25.5516 -2.14082 -10.0364 +1014 4 12.8083 6.68649 36.6117 -1.06896 6.08822 -0.205097 +1015 4 11.642 8.94716 37.2538 22.1051 -1.45756 -27.4817 +1016 4 11.9592 9.50431 35.5025 9.97141 -3.64215 15.7788 +1017 4 13.6538 10.3723 37.0555 -8.09423 13.3796 3.79584 +1018 4 14.2885 9.3339 36.0056 2.60625 13.8446 -5.44478 +1019 4 14.0928 8.83644 37.5176 -15.06 24.3666 -13.6607 +1020 1 6.73429 6.959 34.8261 9.36917 -0.537504 -3.37326 +1021 2 5.68914 7.48312 33.9811 -11.6093 0.198368 -29.7566 +1022 2 4.72257 6.43001 33.3633 23.9678 57.8121 29.6097 +1023 3 3.69345 6.80336 32.8731 -41.5354 18.269 -25.9458 +1024 4 6.5403 7.08067 35.8075 -8.4584 6.57489 23.7637 +1025 4 4.95828 8.08289 34.6274 18.5559 -1.63885 -10.0577 +1026 2 6.30301 8.33887 32.7628 1.61604 -0.894199 46.3222 +1027 2 6.96232 9.68302 33.2113 17.5203 -12.0258 -13.4607 +1028 2 6.11334 10.8061 33.8152 -7.60378 12.6352 19.0416 +1029 3 5.31496 11.4419 33.0422 10.0378 -5.26853 5.86857 +1030 3 6.28181 11.1536 35.05 3.36103 -18.7342 -31.8229 +1031 4 5.5011 8.60814 32.0808 -13.4162 -1.3456 -15.0867 +1032 4 7.01778 7.64283 32.2215 -8.51236 18.4517 -1.11608 +1033 4 7.483 10.1113 32.3225 -5.01151 2.49106 -4.14977 +1034 4 7.84021 9.44334 33.8428 -3.17944 -2.15711 8.7111 +1035 1 4.98957 5.17145 33.408 31.7294 -73.5208 5.3031 +1036 2 4.03057 4.12888 32.9492 20.6717 -14.7005 -20.2168 +1037 2 2.6598 4.36206 33.592 -3.0444 -3.65398 -36.823 +1038 3 2.63368 4.6245 34.7729 -17.9957 9.5377 28.5993 +1039 4 5.93287 4.88555 33.7778 -25.4301 -4.21673 -10.3446 +1040 4 3.97065 4.08898 31.7849 -0.621936 10.7688 28.6704 +1041 2 4.54797 2.73693 33.4323 -9.78314 13.2989 35.3654 +1042 3 5.7396 2.38581 32.8061 3.87836 -1.00687 -28.9834 +1043 4 3.83029 1.94659 33.1597 -9.96533 -6.0451 7.8725 +1044 4 4.7579 2.77573 34.5879 -14.8326 -6.64015 -28.538 +1045 4 6.39905 2.57303 33.4496 16.1931 5.10903 8.49462 +1046 1 1.55493 4.20465 32.7937 9.73391 7.12296 -2.26043 +1047 2 0.143907 4.28394 33.2313 13.768 -18.1657 13.0528 +1048 2 54.6863 2.83094 33.3214 -0.0746788 -18.1404 42.9803 +1049 3 54.7972 2.04898 32.3833 -5.36381 -6.57018 -20.4337 +1050 4 1.75536 3.84626 31.8337 -17.5999 5.97734 12.9737 +1051 4 0.145346 4.72929 34.2869 -5.52407 -1.41906 -16.7638 +1052 2 54.0936 4.99047 32.3072 48.5491 53.4262 27.9832 +1053 3 54.4431 6.39026 32.3568 26.5828 -36.1107 8.98461 +1054 2 52.7233 5.01429 32.8691 -55.1486 3.23885 2.70228 +1055 4 54.1505 4.66496 31.2868 0.0550865 -16.0071 -29.7017 +1056 4 53.7986 6.85268 31.88 -20.6445 25.8891 -20.893 +1057 4 52.6197 5.54793 33.8322 5.93951 -5.3567 9.34144 +1058 4 52.3467 3.98503 32.9647 -9.06602 -5.34833 4.63236 +1059 4 51.9747 5.55452 32.2255 9.49609 -7.51028 -3.22615 +1060 1 54.1802 2.39741 34.5222 -14.8232 32.9081 27.5353 +1061 2 53.4465 1.14651 34.785 33.9277 15.1 -62.0226 +1062 2 52 1.44639 34.4384 -40.9452 -8.29472 -14.3346 +1063 3 51.516 2.52365 34.8247 -1.26544 -9.47139 -8.9244 +1064 4 54.0715 3.07846 35.3501 9.6448 -17.4772 -31.2652 +1065 4 53.9076 0.391021 34.1043 -10.2836 -7.20705 -0.475865 +1066 2 53.6069 0.737389 36.2058 40.6624 3.41232 47.0409 +1067 2 0.15698 0.778637 36.8849 -22.9225 14.5477 7.59965 +1068 2 0.184063 0.045177 38.2545 -1.48959 -18.0819 6.68284 +1069 2 1.19764 0.213126 35.924 -17.0247 17.4527 -16.4279 +1070 4 53.1759 41.6554 36.3315 -4.28574 -19.6707 2.88188 +1071 4 52.9166 1.40322 36.7387 0.80484 4.57892 22.2756 +1072 4 0.570353 1.84035 37.1024 -27.1105 -11.6335 -5.02718 +1073 4 54.3756 0.329349 38.9832 1.77724 8.98271 -8.45905 +1074 4 1.16626 0.241414 38.7954 -11.8595 -7.79047 -8.4361 +1075 4 0.0237 40.841 38.1265 8.8292 11.305 -0.869273 +1076 4 2.1582 0.044818 36.439 11.171 3.86438 -4.7836 +1077 4 1.22244 1.0066 35.1406 25.1303 -1.4606 -0.0516333 +1078 4 0.965216 41.2564 35.3038 -8.75588 -20.9773 6.66787 +1079 1 51.2089 0.49816 33.7614 57.6433 8.13256 28.0245 +1080 2 49.794 0.627079 33.5149 3.58551 37.6409 23.5907 +1081 2 49.1504 41.7362 34.5845 -39.3958 -31.0429 53.6988 +1082 3 49.3072 40.5133 34.7023 12.9245 12.8492 -11.6005 +1083 4 51.5663 41.4343 33.8516 -6.054 3.49016 -14.1934 +1084 4 49.5236 1.72635 33.6347 -1.89472 -11.9516 -1.26615 +1085 2 49.2899 0.093076 32.2111 -20.0469 10.239 -57.1496 +1086 2 49.5504 1.0758 31.0546 44.1484 5.96661 -35.419 +1087 1 48.7105 2.02971 30.4517 -2.34523 -25.3315 39.2373 +1088 2 50.7977 1.22066 30.3277 -75.7848 7.88288 4.96893 +1089 2 49.299 2.59293 29.3763 -23.865 8.39496 11.0232 +1090 1 50.5677 2.14293 29.3127 -12.36 -15.4034 27.3398 +1091 4 48.1533 41.8436 32.187 18.4481 1.21563 9.00361 +1092 4 49.725 40.9798 32.0543 -2.35302 7.24771 -7.56512 +1093 4 47.7373 2.26457 30.8018 19.6426 -7.09987 -8.69392 +1094 4 51.6402 0.582035 30.3922 15.3203 -1.97636 0.19948 +1095 4 48.6832 3.25559 28.7541 24.649 -5.28154 -1.94766 +1096 4 51.2124 2.39582 28.5799 18.4236 6.97779 -14.3308 +1097 1 48.3633 0.438016 35.503 -1.69139 30.1001 11.6909 +1098 2 47.6687 41.7006 36.6492 0.613805 18.6924 -40.9612 +1099 2 46.264 41.3694 36.1307 -7.02361 -30.4834 5.87484 +1100 3 45.3463 0.246853 35.8895 18.8914 5.06283 8.3795 +1101 4 48.1281 1.45816 35.4039 5.5506 -16.4063 -0.101422 +1102 4 48.2062 40.7837 36.9784 6.36967 -2.21031 -8.42979 +1103 2 47.5958 0.687745 37.8565 -25.4558 59.2473 29.5222 +1104 2 46.6931 0.064749 39.0402 -2.78345 4.00632 18.8053 +1105 2 47.0383 40.4557 39.4221 -33.2538 18.6268 -20.4936 +1106 2 46.93 0.927044 40.3419 31.4794 -11.2994 1.29194 +1107 4 47.1354 1.76149 37.5629 9.48386 -42.5729 7.15928 +1108 4 48.6298 0.997945 38.2155 -14.6806 -19.3715 -2.98409 +1109 4 45.5391 0.148422 38.8474 30.3772 -4.98305 -7.99897 +1110 4 47.9695 40.2725 39.9165 32.6255 3.33763 11.188 +1111 4 46.9967 39.7545 38.5575 0.158611 5.44488 0.559019 +1112 4 46.2719 40.0836 40.1333 -2.82757 0.291607 -0.331179 +1113 4 48.0832 1.04093 40.5802 -35.3824 -1.71169 -8.39188 +1114 4 46.4823 0.388091 41.2333 0.118939 13.4124 -7.57083 +1115 4 46.4764 1.95182 40.2253 3.79994 -8.06745 5.67231 +1116 1 46.1155 40.0363 35.9994 32.2071 3.49142 -20.6914 +1117 2 44.9353 39.2817 35.7114 0.014229 -40.6503 61.2515 +1118 2 44.4179 38.8949 37.157 4.06758 -27.6469 18.473 +1119 3 45.1574 38.4668 38.0935 -15.0116 19.769 -34.2637 +1120 4 46.9934 39.487 36.0733 -14.8983 -9.5139 0.794979 +1121 4 44.1193 39.9156 35.4266 -15.9448 22.0113 -37.9939 +1122 2 45.2307 37.9502 34.8403 3.73878 29.7444 42.1248 +1123 2 44.043 37.0324 34.841 -52.9272 -13.7306 14.9234 +1124 2 45.6185 38.368 33.4399 7.42128 1.51593 -38.9882 +1125 4 46.0406 37.394 35.3664 8.69137 1.61483 -3.86581 +1126 4 43.4486 36.945 35.811 20.0159 3.18287 -12.2628 +1127 4 44.3645 35.9957 34.6605 0.118723 -8.68919 -11.9568 +1128 4 43.2413 37.3473 34.1301 7.80666 -3.9283 -7.25571 +1129 4 46.619 38.86 33.4411 -0.357581 -2.40345 0.816384 +1130 4 44.931 39.1517 33.0584 -3.3954 -0.0150932 -1.42103 +1131 4 45.65 37.5606 32.6192 -0.759822 9.78394 24.304 +1132 1 43.0637 38.9039 37.3301 16.2039 -1.11298 52.5829 +1133 2 42.3901 38.4825 38.6382 8.13363 32.9232 -36.228 +1134 2 41.8706 37.0909 38.467 10.8397 -12.8704 71.8875 +1135 3 41.4837 36.7016 37.4073 -23.2793 -18.8499 -56.9312 +1136 4 42.5052 38.9697 36.5072 -31.8536 4.61581 -21.2592 +1137 4 43.1805 38.4127 39.3754 18.2924 -0.774441 22.1039 +1138 2 41.3003 39.5089 39.1545 11.9555 -3.56475 0.849013 +1139 2 41.9844 40.8891 39.6202 11.8289 -38.672 35.4909 +1140 2 41.1032 0.170603 39.4187 0.299182 35.0028 -21.1028 +1141 2 42.4599 40.8175 41.1074 30.4283 -6.43954 -3.58257 +1142 4 40.7378 39.0113 40.0259 3.55617 13.764 -16.8053 +1143 4 40.5882 39.6834 38.2893 4.7664 -2.44084 15.6093 +1144 4 42.9174 41.0251 39.0897 16.4872 7.11459 -27.4623 +1145 4 41.5448 1.21778 39.6878 -5.64292 -30.3916 -9.38981 +1146 4 40.1969 0.063548 40.0003 -21.2204 -0.202137 11.1399 +1147 4 40.8028 0.152067 38.3319 -0.566182 12.1591 9.51378 +1148 4 41.6814 40.5448 41.8308 -8.42244 -8.91154 4.32363 +1149 4 42.887 41.7652 41.4977 -6.37808 7.37928 -6.87517 +1150 4 43.378 40.1338 41.1957 -24.337 0.845851 0.000130478 +1151 1 41.833 36.287 39.5864 -11.7269 -9.12911 -32.1296 +1152 2 41.2021 34.942 39.6247 -13.3362 -7.3841 -33.9439 +1153 2 39.8438 35.1095 40.3167 -2.23182 -18.8086 0.488263 +1154 3 39.8319 35.4679 41.5133 -14.6884 5.15074 -23.9167 +1155 4 42.1857 36.6275 40.4819 6.41783 1.01312 8.70708 +1156 4 41.0734 34.4248 38.4971 0.391294 34.8961 43.783 +1157 2 42.0436 33.9307 40.4129 10.4134 -33.9193 29.8386 +1158 2 41.3224 32.6645 41.0046 18.9395 -8.84266 -15.0635 +1159 2 42.1741 31.41 41.1086 26.4224 -37.0889 -5.20117 +1160 1 43.3231 31.527 0.12404 8.16009 54.2467 4.49909 +1161 2 44.392 30.7336 0.312631 -11.8213 -13.5239 -25.8004 +1162 1 44.683 29.6211 41.5456 -0.875823 -13.5136 -9.93246 +1163 1 45.3567 31.1357 1.10637 -40.5913 52.4111 16.4216 +1164 4 42.6035 34.3028 41.3288 -3.49471 12.9719 -23.3931 +1165 4 42.7742 33.539 39.6653 10.0701 4.50298 5.32726 +1166 4 40.5106 32.3417 40.3808 -25.7726 1.2565 -24.6898 +1167 4 40.8602 32.7415 0.05618 -15.4481 23.3498 31.3369 +1168 4 42.5775 31.2408 40.0556 -4.97325 -9.97334 14.9806 +1169 4 41.5239 30.4863 41.4302 18.1675 25.5375 -11.7586 +1170 4 43.4773 32.5278 0.495625 -12.2609 -36.3484 -6.98406 +1171 4 44.1847 29.2591 40.6938 -0.904676 10.2844 18.7349 +1172 4 45.5197 29.0942 41.8602 -5.70345 -5.08504 -8.10101 +1173 4 45.1981 31.9946 1.67722 9.89922 -9.52065 -4.53153 +1174 4 46.1063 30.5613 1.39407 36.7186 -26.409 10.0907 +1175 1 38.7328 34.6894 39.6013 4.46457 11.7984 -0.102478 +1176 2 37.3765 34.7683 40.1611 -21.3466 -3.56213 -4.53749 +1177 2 37.2086 33.6902 41.246 35.3807 -34.3386 -58.3615 +1178 3 37.7056 32.5617 40.9531 -12.3371 14.3328 36.9617 +1179 4 38.7903 34.2139 38.6548 1.70782 19.6852 25.699 +1180 4 37.2103 35.7436 40.6571 5.74575 10.1154 -0.0963519 +1181 2 36.2415 34.546 39.0669 -3.18027 -0.0437456 15.212 +1182 2 36.1408 35.6492 37.9204 39.4301 -27.8538 10.4422 +1183 2 35.3755 35.0392 36.7616 2.61616 7.91146 -44.6699 +1184 2 35.4893 36.9279 38.4153 -43.6456 26.6605 -35.0263 +1185 4 35.2587 34.5127 39.627 5.22859 0.340849 -7.95454 +1186 4 36.3572 33.4874 38.6664 0.260323 14.7009 0.217726 +1187 4 37.2087 35.8382 37.5664 -16.1128 3.65721 5.42823 +1188 4 35.4477 35.6456 35.7653 9.36321 -17.9472 26.5571 +1189 4 34.3056 35.0154 36.9225 -21.8403 -4.8414 12.2215 +1190 4 35.6878 33.9672 36.6241 -0.675121 9.51327 -11.2908 +1191 4 35.3533 37.7352 37.5449 14.646 -26.9923 30.0517 +1192 4 36.0883 37.365 39.2255 0.238586 8.99863 9.94523 +1193 4 34.398 36.7236 38.7331 27.4296 3.60145 2.66053 +1194 1 36.5178 33.9861 0.43319 -0.886806 18.5628 10.9627 +1195 2 36.4316 33.2481 1.68402 -23.714 -26.6299 -2.13495 +1196 2 35.1244 33.7124 2.42366 15.5385 -30.3313 2.36588 +1197 3 34.7644 34.9026 2.51705 2.20922 -14.5348 -10.7235 +1198 4 35.9714 34.8641 0.38304 3.21168 -9.87759 6.15105 +1199 4 36.3983 32.0948 1.44989 -1.82422 33.6343 5.26777 +1200 2 37.6595 33.5578 2.59019 11.8109 -15.526 -8.95992 +1201 2 37.7925 32.6548 3.8947 -1.46637 37.0951 -40.7395 +1202 2 39.0729 32.9162 4.76145 9.33062 17.9701 -6.69315 +1203 1 39.1272 34.3057 5.34055 -12.0513 -47.2871 -14.6565 +1204 2 40.0361 34.6964 6.22226 19.4309 2.99614 33.8109 +1205 1 41.0505 33.9844 6.76852 5.72064 -28.58 -41.8643 +1206 1 39.7581 35.8909 6.75898 -16.291 -41.0737 -43.8581 +1207 4 37.6558 34.6526 2.69615 5.74115 8.80853 20.4616 +1208 4 38.5677 33.342 1.97837 2.62182 1.38243 0.976295 +1209 4 37.7082 31.6119 3.52088 7.51898 -7.43262 10.1799 +1210 4 36.8684 32.8569 4.46033 -3.22235 -4.22142 15.6354 +1211 4 40.0987 32.7161 4.26669 -27.6432 -2.90908 0.926336 +1212 4 38.962 32.1623 5.56307 10.4764 0.325422 12.3641 +1213 4 38.2956 34.9173 5.26655 4.54825 -8.39051 -8.34855 +1214 4 41.5169 33.1039 6.38476 -28.6266 25.8655 1.14646 +1215 4 41.608 34.3491 7.51377 7.8916 19.9746 23.1278 +1216 4 38.9281 36.336 6.40181 -18.5651 19.0558 1.42199 +1217 4 40.2702 36.4189 7.40653 35.8571 19.9594 40.0309 +1218 1 34.4344 32.6714 2.9841 11.9274 27.4669 5.1488 +1219 2 33.2874 32.9292 3.81699 -8.08564 -7.68863 -5.88537 +1220 2 32.3224 31.7651 3.90854 -17.2979 -17.3182 38.1098 +1221 3 31.6331 31.611 4.98833 24.1293 6.49939 -41.9496 +1222 4 34.8176 31.7057 3.00707 -6.83555 3.8884 -0.368261 +1223 4 33.5991 33.291 4.83995 -4.39941 -8.915 -13.4113 +1224 4 32.6658 33.7351 3.38441 -0.220857 8.92322 -1.65762 +1225 1 32.2676 30.8833 2.86064 7.18924 -6.28537 -11.1453 +1226 2 31.5304 29.6622 2.84554 -44.3988 -8.55194 41.4736 +1227 2 32.0114 28.4719 1.98523 24.1065 42.5964 20.3644 +1228 3 31.2338 27.9142 1.1781 -2.45095 -15.5808 -11.9787 +1229 4 32.835 30.9065 1.99868 7.60542 11.1676 6.22148 +1230 4 31.4977 29.325 3.94534 -1.848 -5.68036 -21.1002 +1231 4 30.428 29.9278 2.63242 23.021 -11.1829 0.219584 +1232 3 33.2484 28.1785 2.03016 -12.1294 -5.65166 -6.61988 +1233 6 29.6841 33.0367 2.60309 -21.6771 -19.3453 -3.47113 +1234 4 28.7948 33.122 2.96731 -0.0142705 6.34055 1.55972 +1235 4 29.6278 32.12 2.27587 17.6678 13.2788 -5.74715 +1236 6 1.91248 24.7582 28.0699 4.20875 0.224039 17.8866 +1237 4 1.01839 24.445 28.2798 3.51323 0.855994 -2.65004 +1238 4 2.43926 24.5752 28.8738 -5.90795 -3.90565 -13.7536 +1239 6 8.97597 35.4266 7.06834 5.04 -9.06312 -1.25332 +1240 4 8.25108 36.0541 6.94232 -0.597114 -1.88223 0.564045 +1241 4 9.78632 35.9205 6.90416 2.6498 8.25727 -2.9232 +1242 6 37.9306 35.2271 23.5275 -29.4197 8.6633 8.88923 +1243 4 37.6331 35.3765 22.6307 -13.538 -1.59668 -6.74716 +1244 4 38.842 35.1051 23.4294 41.2281 -9.97035 -1.96517 +1245 6 11.37 34.6061 20.3231 29.8185 18.8627 -18.7977 +1246 4 10.4583 34.7066 20.5358 -23.2141 -5.0309 12.4901 +1247 4 11.7775 33.9686 20.9051 -0.738527 -14.291 8.66526 +1248 6 3.04799 13.1152 13.5136 35.0099 19.4917 13.0876 +1249 4 2.1896 12.8159 13.7818 -12.1985 -3.35561 6.33527 +1250 4 3.35102 13.7724 14.1976 -9.84998 -14.2313 -17.3692 +1251 6 9.17749 22.3786 24.885 -4.81993 3.49977 17.5169 +1252 4 8.99718 21.9861 24.0258 2.67933 0.293026 -6.97176 +1253 4 8.3097 22.5185 25.3032 2.93356 -2.2731 -6.67367 +1254 6 31.1417 36.1188 7.44168 3.96214 -4.62609 4.57576 +1255 4 30.9859 35.1633 7.26174 3.91063 19.8072 -8.10584 +1256 4 31.8759 36.4086 6.86762 -9.43736 -11.0335 0.220205 +1257 6 20.3122 0.171955 30.1364 24.228 8.43021 7.74329 +1258 4 20.1467 1.09565 29.8896 -9.06662 -5.17995 0.122132 +1259 4 21.2388 0.205679 30.4532 -11.6638 -2.99571 -4.85501 +1260 6 32.6752 3.01477 5.14905 7.73556 0.409651 25.0992 +1261 4 32.0607 2.27652 4.98052 6.16059 10.1356 9.58904 +1262 4 32.7887 3.0902 6.13894 -10.3787 -11.0045 -24.4474 +1263 6 26.2394 8.28697 11.5977 20.1187 4.68976 23.8355 +1264 4 26.2546 7.39802 11.997 -1.81228 7.23555 -2.12718 +1265 4 26.8422 8.82061 12.1901 -18.4274 -19.7459 -23.7973 +1266 6 1.08156 20.2558 0.892389 0.445896 -40.4816 -11.3523 +1267 4 0.921065 19.2784 0.845371 -9.22979 28.4068 22.5673 +1268 4 1.8129 20.2775 0.290341 19.5395 18.0975 -11.5753 +1269 6 29.152 22.9159 1.42964 -10.353 11.3862 1.77115 +1270 4 28.6638 23.7219 1.70393 12.045 -15.0113 -5.27942 +1271 4 29.6471 22.6066 2.20087 0.367353 7.17244 2.17898 +1272 6 34.1439 34.8173 6.47837 -14.6134 34.7664 -13.6599 +1273 4 34.8234 34.3556 6.01831 17.3611 -13.8412 -2.82442 +1274 4 33.8746 34.3136 7.2252 -0.385324 -14.0922 18.4225 +1275 6 25.1602 37.1811 26.5285 37.3138 -10.4299 -24.6025 +1276 4 24.6611 37.8475 26.9305 -29.1138 25.753 30.5337 +1277 4 25.9902 37.6718 26.3423 -2.02618 -10.7722 -5.27175 +1278 6 14.5359 22.233 15.6757 -38.1082 -52.4317 -17.2355 +1279 4 14.0373 21.3219 15.6008 31.4468 51.1923 15.0921 +1280 4 14.2115 22.7284 14.9124 6.42666 2.88962 4.6194 +1281 6 2.85765 5.85542 4.07926 -11.0889 31.9932 11.5474 +1282 4 3.43051 5.71014 4.8302 4.50985 -17.8875 11.7313 +1283 4 2.47546 6.74142 4.27679 -1.8522 -19.462 -7.62003 +1284 6 27.6173 26.7153 22.7048 3.02536 -24.7668 37.2 +1285 4 26.7794 26.2561 22.7471 -5.49099 -10.4557 3.23975 +1286 4 27.5338 27.2427 21.9498 -2.81898 29.5538 -40.3285 +1287 6 17.7815 0.60275 22.3967 -9.44347 22.192 16.8557 +1288 4 17.1106 0.664367 23.1174 8.05472 -4.70436 -13.4643 +1289 4 18.0991 1.53066 22.3547 -2.50437 -12.3009 -7.04453 +1290 6 8.08803 9.43976 10.5674 4.80966 -47.9744 28.0614 +1291 4 8.01535 10.2871 10.1695 -8.25869 32.7817 1.56345 +1292 4 8.12483 9.46261 11.5696 0.628604 12.1613 -30.4224 +1293 6 15.3459 8.71493 30.7579 -11.6347 7.91644 6.32427 +1294 4 15.6589 9.0755 29.9373 15.0271 -3.29406 -15.5675 +1295 4 14.5238 9.21191 30.8811 4.80809 -7.40019 11.405 +1296 6 11.0133 17.2839 37.5617 38.0352 -12.2544 -11.7999 +1297 4 10.7898 18.2056 37.405 -17.5453 -0.0751596 7.29682 +1298 4 10.2607 16.7791 37.8546 -17.0302 3.42722 4.74802 +1299 6 42.1004 25.1498 20.3879 -5.861 18.5914 -24.6259 +1300 4 41.6093 25.7579 19.7998 14.6917 -4.46771 2.10695 +1301 4 41.6207 25.2703 21.1911 -4.19275 -5.86855 25.2901 +1302 6 25.8665 4.70671 33.8486 1.7241 -2.25531 12.4518 +1303 4 25.7694 4.46132 32.9448 -0.891619 -14.6084 -22.569 +1304 4 25.7648 5.65611 33.7952 0.475958 14.7418 11.4125 +1305 6 28.7412 10.81 24.3536 52.8166 -39.1996 0.778281 +1306 4 29.1275 10.6396 25.241 -21.7381 14.0631 -10.6288 +1307 4 29.4032 10.2753 23.8346 -27.1554 16.6107 -4.2243 +1308 6 5.01189 41.8147 11.1021 -10.1881 -24.042 21.7575 +1309 4 5.95007 41.5814 10.9281 -9.39093 5.64723 11.7156 +1310 4 4.65803 41.218 11.8386 16.8172 15.7397 -32.6044 +1311 6 51.752 12.7769 30.1551 43.115 4.76279 10.9474 +1312 4 51.4305 13.1775 29.3474 0.253404 7.28674 -13.194 +1313 4 52.748 12.9494 30.1798 -32.3905 -5.4963 0.108494 +1314 6 7.60816 6.20909 6.53323 -10.2625 -22.9413 3.332 +1315 4 6.75131 6.36879 6.93991 1.04412 16.1391 1.16177 +1316 4 7.47061 5.28848 6.27373 8.51121 0.713964 -9.51027 +1317 6 14.6661 26.987 30.1548 0.873164 4.36141 0.355215 +1318 4 14.582 27.1099 31.1251 1.36022 -4.92112 -14.8153 +1319 4 15.2266 27.7026 29.8055 -8.21389 -0.931444 11.6021 +1320 6 15.3264 3.73283 21.1643 -10.33 -3.58504 -6.01241 +1321 4 14.8638 4.27764 21.8464 -0.83547 -19.2341 -16.6374 +1322 4 14.7237 3.15769 20.6119 12.9204 22.2517 21.9232 +1323 6 18.6273 30.44 6.46759 12.0392 -23.7352 17.6185 +1324 4 19.0475 29.6706 6.98693 -16.3462 35.3997 -15.3304 +1325 4 19.3457 31.0864 6.33287 -5.93154 -6.64461 4.30044 +1326 6 40.7697 1.30953 12.81 -7.42069 2.69181 -0.220133 +1327 4 39.8771 1.67487 12.9664 8.30469 -1.85755 -8.75546 +1328 4 41.0842 1.69163 11.9727 1.23155 -3.30642 0.910493 +1329 6 17.7383 20.7435 41.5913 -9.25323 7.68498 -13.188 +1330 4 16.7989 21.0745 41.5362 27.0903 -5.35562 -1.00027 +1331 4 18.2994 21.1605 40.9095 -9.45455 4.50919 10.4973 +1332 6 20.4558 2.13279 12.3403 -30.0447 18.1891 -47.0851 +1333 4 19.8108 1.39557 12.2573 15.3988 9.29294 19.6505 +1334 4 20.198 2.64755 11.5038 12.9177 -17.2886 33.121 +1335 6 9.85302 37.1833 18.074 6.71136 -14.9304 -23.7857 +1336 4 9.92221 37.5908 18.9423 10.0316 4.42551 4.50256 +1337 4 10.7455 37.1149 17.635 -18.8442 6.56171 18.5414 +1338 6 22.8282 7.40677 18.9114 -6.23678 0.804763 -35.7596 +1339 4 23.277 7.74075 18.0859 -11.7777 -2.90663 21.4919 +1340 4 21.8757 7.287 18.6972 16.9035 1.85128 0.334711 +1341 6 12.8573 6.85868 39.0594 6.78943 -21.4649 -19.4044 +1342 4 12.3495 7.63841 39.2092 -16.9303 20.8315 3.03628 +1343 4 13.4346 6.77393 39.8096 4.28484 1.06254 16.6435 +1344 6 10.1565 2.40612 23.2517 -6.6479 23.561 31.1588 +1345 4 10.4099 1.98923 22.4441 -4.01424 -6.38426 -29.0568 +1346 4 9.49005 3.10319 23.0571 9.63138 -11.2124 -3.87372 +1347 6 12.5542 20.2161 19.5705 -7.34833 3.07917 -34.9419 +1348 4 11.7057 19.8107 19.7825 -3.93433 -3.45282 3.31954 +1349 4 12.4683 20.3478 18.5882 13.2674 0.522362 30.6915 +1350 6 53.8557 6.35775 18.9347 50.5758 7.3162 -16.743 +1351 4 53.0168 6.07594 19.2456 -23.2698 -10.9568 16.0684 +1352 4 54.5479 6.04339 19.5529 -19.4302 5.44353 -5.27334 +1353 6 1.75058 4.00903 13.2441 23.5728 -28.6973 -20.2265 +1354 4 1.21884 4.54583 13.7916 -24.4496 15.7193 15.6535 +1355 4 1.39876 3.10072 13.3493 7.47096 11.1043 -1.96467 +1356 6 2.68902 16.4655 4.58797 17.5454 -16.7281 26.1549 +1357 4 3.46748 16.2798 5.17846 -23.6637 11.3752 -17.7986 +1358 4 3.0109 17.1109 3.97132 2.36318 9.59715 -15.9168 +1359 6 22.6274 7.40182 35.0529 -33.099 -8.93325 -69.8706 +1360 4 21.8922 7.07895 34.3703 46.348 20.1786 48.898 +1361 4 22.5995 6.76718 35.7474 -8.35572 -20.8537 22.0506 +1362 6 30.6396 27.885 19.9 19.0923 35.3411 -25.0547 +1363 4 31.1106 28.5954 19.3754 -18.5592 -24.8751 19.2783 +1364 4 29.9814 27.5098 19.295 5.17179 -8.35919 5.46264 +1365 6 18.3573 9.54392 6.2041 9.96047 7.12844 39.1223 +1366 4 18.327 9.09374 5.37857 3.10343 -12.6247 -24.8999 +1367 4 19.1177 9.18386 6.70986 -9.9052 0.872737 -11.1311 +1368 6 21.018 30.3894 30.8381 -12.2875 -2.46479 40.1773 +1369 4 21.7266 31.0151 30.932 9.98027 8.24448 -8.07198 +1370 4 20.7269 30.28 31.7939 -0.642204 -5.24287 -40.3987 +1371 6 28.323 4.36597 15.0837 1.12527 39.8195 10.6489 +1372 4 27.8986 3.55092 15.2676 -12.4099 -32.2848 2.02696 +1373 4 29.0009 4.19376 14.4446 14.1396 -7.65384 -8.86362 +1374 6 12.7814 0.64254 16.5262 -20.2521 41.8336 -1.49998 +1375 4 13.0387 1.47629 17.0069 -1.64601 -27.4009 -13.133 +1376 4 12.0897 0.933072 15.8712 20.715 -4.46996 16.4219 +1377 6 27.5603 35.1844 8.24072 -26.8161 -1.20469 12.7263 +1378 4 28.0791 35.3455 7.47089 6.94403 2.76433 -19.537 +1379 4 26.8275 34.582 7.96906 18.9853 12.4469 9.56437 +1380 6 24.0704 5.17451 40.9985 43.9791 -14.9803 45.716 +1381 4 24.6298 5.96615 41.2045 -19.6374 -8.83437 -20.0494 +1382 4 23.3625 5.28724 40.4007 -22.1054 20.8081 -27.5224 +1383 6 16.8467 24.9145 28.3061 -32.8066 71.0274 -23.4158 +1384 4 15.8676 25.1613 28.454 39.6061 -31.4713 1.92714 +1385 4 17.0718 25.6559 27.6632 3.37355 -28.1253 20.4487 +1386 6 20.8411 12.7971 17.0095 43.3655 -24.1139 -5.17775 +1387 4 20.9692 13.6698 17.4217 0.0861137 -1.96629 -7.53612 +1388 4 21.7712 12.4167 16.7645 -47.1299 18.5523 16.3808 +1389 6 35.7683 23.0344 30.9263 1.08866 -13.108 5.55839 +1390 4 34.803 23.1301 30.928 3.64223 -3.31893 2.04139 +1391 4 35.9803 22.5404 31.7512 0.26244 15.2618 -11.5602 +1392 6 36.3065 21.404 25.8788 21.1988 16.3215 -11.4752 +1393 4 35.3711 21.2912 25.8279 -29.04 -8.19979 -7.71966 +1394 4 36.6742 20.6179 26.2596 7.44281 -15.7003 9.85929 +1395 6 13.4865 6.74911 5.29345 -32.6693 78.3701 45.7352 +1396 4 13.9616 6.05619 4.98306 41.5093 -80.328 -47.9816 +1397 4 12.7805 7.00791 4.71674 -14.9335 -5.37764 -13.3979 +1398 6 20.8104 20.4092 13.7653 1.99296 11.0688 -14.7475 +1399 4 21.268 20.4545 14.5989 11.9976 -3.76106 7.6647 +1400 4 19.8959 20.3184 13.9984 -15.4264 -4.27358 -1.02469 +1401 6 20.3637 29.125 1.38742 -7.39452 3.20569 15.6829 +1402 4 20.6257 29.8678 1.97015 -13.6171 -7.9879 -3.97808 +1403 4 19.4728 28.7955 1.69287 22.5847 10.4694 -9.78123 +1404 6 50.8792 13.1212 37.2655 -4.22961 23.9091 37.9372 +1405 4 51.3893 12.5589 37.8771 -2.47029 4.54984 -9.0483 +1406 4 50.5869 13.8674 37.8656 5.03029 -21.5284 -25.2034 +1407 6 33.9282 34.1694 20.494 -12.758 16.9363 4.62304 +1408 4 33.9505 34.3661 19.5368 -1.52487 0.481952 13.5649 +1409 4 33.2327 34.7631 20.901 14.0918 -19.53 -17.3949 +1410 6 26.2111 28.0581 27.5584 -15.6012 -12.4051 -9.62147 +1411 4 26.6887 28.3319 28.3498 -5.67664 4.83839 -0.885474 +1412 4 25.2376 28.0657 27.7416 20.5709 -1.16679 -1.23567 +1413 6 7.682 21.3042 4.28531 -31.6563 9.11884 52.3302 +1414 4 8.36407 20.9023 3.81015 41.1991 -18.6864 -33.8238 +1415 4 7.19271 21.9105 3.74865 -6.01459 10.7978 -19.2095 +1416 6 22.0049 15.1615 5.91526 -5.59087 32.8095 7.59658 +1417 4 22.5291 15.4011 5.14076 -1.79158 -8.25489 -6.60562 +1418 4 21.8369 14.2416 6.04435 2.97447 -25.4321 -3.26552 +1419 6 21.7136 24.0096 3.8157 22.5859 -13.9702 -11.1371 +1420 4 22.6792 24.1846 3.95073 -20.2229 4.30251 2.28349 +1421 4 21.6957 23.2604 3.18041 -1.04284 4.75891 13.5064 +1422 6 11.5672 23.7812 12.5534 10.6653 17.5289 -0.525849 +1423 4 11.8567 24.7317 12.4283 -11.704 -31.033 2.93832 +1424 4 11.2483 23.6794 13.4494 -5.02459 5.94744 7.15157 +1425 6 32.3679 18.058 29.8144 -2.59991 12.5874 27.6023 +1426 4 33.2958 17.8537 29.9681 1.40206 -2.08885 -2.88861 +1427 4 32.1708 17.8352 28.9168 3.64727 -16.5589 -23.8097 +1428 6 9.27501 12.3901 30.3257 8.89695 -9.73537 -4.18026 +1429 4 8.97738 13.0169 30.9954 -4.04452 2.00113 -0.0309771 +1430 4 10.1278 12.0418 30.6776 -19.7256 9.24572 -11.0885 +1431 6 40.1671 25.9203 9.1352 -31.1658 -6.55029 4.71016 +1432 4 40.7952 25.2818 9.45931 8.36253 -10.0667 -0.250848 +1433 4 40.6474 26.7215 9.01492 17.3912 21.2934 -6.4579 +1434 6 43.1616 32.3487 37.3267 7.45809 -19.2286 11.3512 +1435 4 42.8399 32.8446 36.5586 -11.2032 -5.45956 10.184 +1436 4 42.4733 31.7245 37.6799 8.3011 17.0164 -20.2151 +1437 6 44.0911 6.28198 31.259 8.64406 -6.47735 -33.2401 +1438 4 43.4563 6.84482 31.6606 -21.1773 24.4303 10.8162 +1439 4 44.5952 5.92873 31.9644 15.9286 -14.2375 24.3689 +1440 6 10.2063 18.8787 19.6978 14.6089 -0.63771 -2.74842 +1441 4 10.128 18.3979 20.5267 6.04825 -4.13467 -1.20166 +1442 4 9.36891 19.3219 19.635 -15.0357 8.38504 -1.1225 +1443 6 7.0561 15.5922 15.0299 -16.4573 19.9198 -23.3889 +1444 4 7.18612 15.4783 14.0721 1.05096 2.95086 4.94392 +1445 4 7.41457 14.833 15.4354 13.8635 -34.6267 13.25 +1446 6 24.544 3.4899 27.8655 -14.5565 -8.97091 -7.81951 +1447 4 23.6823 3.28725 28.2588 1.61952 11.0081 14.175 +1448 4 24.3729 3.16547 26.9791 10.0044 -2.74415 -7.35546 +1449 6 54.4109 31.8087 9.71194 -6.99911 23.6955 33.3298 +1450 4 53.8413 31.5567 9.00593 -8.22136 -4.9258 -26.1741 +1451 4 54.0752 32.6964 9.97695 10.2913 -15.383 -7.59421 +1452 6 6.81072 17.0817 36.2069 -39.6649 -0.569341 -18.8672 +1453 4 5.9036 16.7161 36.0961 17.2423 3.35707 18.397 +1454 4 7.03883 17.1994 35.2786 19.8939 2.17194 6.76773 +1455 6 28.6373 7.46216 20.4204 -3.00228 3.72915 -26.9716 +1456 4 27.791 7.71165 20.8314 -1.23568 -3.59083 -7.19581 +1457 4 28.5788 7.67124 19.4449 -3.89686 1.20908 30.1283 +1458 6 17.0427 1.7136 8.36469 -7.39711 4.96373 -17.441 +1459 4 16.9511 0.79552 8.17539 8.34993 -30.6792 14.2707 +1460 4 16.7364 2.03503 7.50962 2.58977 23.9868 7.32556 +1461 6 19.1319 19.334 35.5748 25.2315 11.3156 3.71898 +1462 4 18.4163 18.7293 35.4559 -12.7574 -15.0058 -3.77114 +1463 4 19.9108 18.8059 35.8312 -7.49406 2.79856 2.97864 +1464 6 7.31044 31.3665 13.5876 -12.5896 -10.3186 -18.1643 +1465 4 6.86348 30.5057 13.838 5.41483 30.5465 -8.86898 +1466 4 6.71656 31.9291 13.023 7.05746 -22.9991 7.02109 +1467 6 16.6555 5.24573 12.8486 0.44122 -36.1931 20.2204 +1468 4 17.4189 5.79101 12.9112 23.6003 17.0932 2.01526 +1469 4 16.8511 4.45507 13.4194 -12.0332 11.5633 -21.5138 +1470 6 43.8917 12.7482 34.58 -33.2024 -13.6106 -1.45858 +1471 4 43.9807 13.5999 34.156 2.60816 15.5254 -0.13451 +1472 4 42.9242 12.5381 34.5161 22.3754 -3.96122 -2.5942 +1473 6 42.656 36.4522 28.5282 -7.17959 22.9727 1.13167 +1474 4 42.279 37.3416 28.6522 -7.55712 -15.8866 -0.526154 +1475 4 43.5285 36.675 28.2003 16.3904 -10.8581 0.329061 +1476 6 35.3704 15.0467 6.02622 35.7531 43.3754 17.6476 +1477 4 35.9258 15.8884 5.86958 -26.5611 -35.5954 0.991204 +1478 4 34.7923 14.9488 5.27074 -5.69332 -0.0870189 -10.0798 +1479 6 19.4034 5.85396 6.19026 -42.6676 -37.2433 -25.4755 +1480 4 18.4973 6.11578 6.46985 14.7962 -6.51198 7.73248 +1481 4 20.0178 6.47164 6.48735 29.6225 43.4574 23.1864 +1482 6 29.2636 38.16 6.98139 -51.0091 34.2659 0.167673 +1483 4 28.4794 38.0546 7.56687 16.6219 5.90534 -14.0005 +1484 4 29.8812 37.5458 7.29338 34.0617 -33.3732 10.6718 +1485 6 19.3639 26.1879 8.4772 -1.75021 -19.5484 18.4946 +1486 4 19.3765 25.7536 9.37133 0.505418 11.6152 -20.7618 +1487 4 20.132 25.8039 8.02679 -2.64689 1.58972 6.88257 +1488 6 4.91801 16.6546 6.12902 16.8332 -1.31437 8.04366 +1489 4 5.58152 17.3 5.84506 -6.45866 4.1219 -0.991793 +1490 4 5.39084 15.8022 6.09449 -7.75564 17.9483 -2.53018 +1491 6 6.07873 16.6931 28.0679 20.4204 4.35008 -35.2212 +1492 4 5.19925 16.4426 27.8453 -29.7482 -9.15572 9.47762 +1493 4 6.44387 16.7631 27.1426 -3.77999 2.92972 38.3228 +1494 6 21.7313 29.3584 22.0941 -19.989 26.599 40.0594 +1495 4 21.5191 30.3374 22.0902 3.30888 -28.6715 -0.0155919 +1496 4 21.2646 29.0087 22.9228 20.4195 8.84702 -28.341 +1497 6 24.487 0.545827 12.8459 24.5625 -19.0276 8.44191 +1498 4 24.0381 0.883409 12.0817 -9.22903 10.6064 -10.7293 +1499 4 24.0836 0.980384 13.5911 -6.14963 8.46579 8.44801 +1500 6 18.4109 28.2545 40.3162 -15.9129 36.5713 -32.2972 +1501 4 18.3366 27.7076 41.0573 0.952339 -31.6797 34.0712 +1502 4 19.1875 27.9677 39.8503 10.0284 -2.61836 -5.50219 +1503 6 10.3807 17.4604 21.8947 -1.20821 -16.3296 3.13877 +1504 4 9.80057 16.6779 21.8113 10.8468 3.86983 1.60142 +1505 4 10.0443 17.9356 22.6521 -9.33664 9.03137 6.2204 +1506 6 13.5404 13.3591 39.6327 12.5768 11.767 30.0264 +1507 4 13.9188 14.1992 39.2886 -9.97897 -11.5724 13.3172 +1508 4 13.5464 13.3749 40.6413 1.33606 5.90172 -38.0522 +1509 6 19.5508 26.0247 24.7387 -47.8665 -1.21537 -13.2845 +1510 4 19.6189 25.3328 24.097 -5.62542 -9.91951 -19.3965 +1511 4 20.3649 25.9852 25.1641 45.3739 3.88293 31.7071 +1512 6 8.93445 25.8823 20.0822 -10.4543 -29.9419 8.18251 +1513 4 8.35083 26.4773 20.5043 -33.2288 11.519 27.1484 +1514 4 9.504 26.5029 19.6962 43.6798 16.1155 -28.0388 +1515 6 13.4493 41.2138 30.5102 -4.84662 -36.1256 25.75 +1516 4 14.2597 41.094 31.0483 -5.58856 8.18726 -8.9115 +1517 4 12.8416 40.5025 30.8796 12.8197 27.661 -18.9522 +1518 6 21.1596 21.6794 11.1163 10.7366 20.8259 2.41134 +1519 4 20.9554 20.8709 10.6777 -10.2383 -24.5438 -10.817 +1520 4 21.2276 21.4421 12.046 -2.84377 -3.57945 5.82209 +1521 6 43.5643 10.3136 15.5616 17.5969 -21.741 5.94749 +1522 4 43.2379 9.48961 15.149 2.99942 14.1859 3.68588 +1523 4 42.9802 11.0242 15.3396 -21.8087 10.2132 -10.2755 +1524 6 23.5302 5.07333 12.3088 -23.5628 55.8128 -25.3063 +1525 4 23.4112 4.1923 12.0373 1.19089 -49.3933 -5.08619 +1526 4 23.0178 5.53904 11.5656 24.5614 -12.3881 30.382 +1527 6 9.28539 15.401 4.24759 1.63269 -5.62651 -9.8947 +1528 4 9.02922 16.1115 4.82738 -12.4128 14.4693 4.40189 +1529 4 9.90895 14.9318 4.78697 15.8319 -9.58935 3.85081 +1530 6 26.711 10.8797 17.566 5.43365 -10.3343 -26.0937 +1531 4 26.4818 11.0142 18.4585 -6.06422 3.32013 41.5711 +1532 4 26.8019 11.7518 17.1937 0.341074 3.88847 -5.26754 +1533 6 26.0592 23.5875 33.6794 25.1455 50.9154 21.2543 +1534 4 25.4682 24.0785 33.1024 -8.24785 -6.01089 -9.80751 +1535 4 26.6604 24.3213 34.0779 -26.6739 -38.162 -12.8336 +1536 6 7.57385 10.4949 28.9097 -14.7972 2.07126 0.456687 +1537 4 6.75277 10.5859 29.4011 -5.17598 -12.8295 -3.89358 +1538 4 8.06091 11.2035 29.3139 24.0536 5.38729 3.77373 +1539 6 16.4953 16.9073 24.6459 13.4535 22.6993 31.6086 +1540 4 15.9363 17.7011 24.6942 7.46422 -1.49957 -9.096 +1541 4 16.1467 16.4045 23.9375 -12.5815 -17.1437 -28.632 +1542 6 12.5505 12.7927 0.441559 26.7797 -18.4986 61.4448 +1543 4 12.8902 12.7839 1.42408 -16.6807 15.1369 -51.7767 +1544 4 12.972 11.9767 0.117581 -17.3776 3.59908 -10.4186 +1545 6 6.80454 2.46926 9.04378 10.3033 -16.1572 19.5551 +1546 4 7.05376 2.92505 9.85651 -1.04006 9.78535 -3.84035 +1547 4 7.36555 1.67892 9.06596 -6.07141 -1.3767 -9.09165 +1548 6 28.8788 11.8454 12.005 47.3119 33.3239 7.75537 +1549 4 28.2175 12.4307 11.6211 -4.89696 7.77957 0.00959457 +1550 4 29.7805 12.2922 11.8721 -37.0304 -14.6121 1.30522 +1551 6 44.6756 32.5924 29.7091 -46.8228 -4.47104 18.0754 +1552 4 43.7214 32.9254 29.5641 42.8383 -8.78111 -1.84094 +1553 4 44.558 31.8742 30.3802 4.31467 20.1075 -17.1439 +1554 6 28.6099 15.1189 32.288 -8.09168 -64.7739 -6.10589 +1555 4 29.0591 15.887 31.9855 13.2175 18.1439 -15.8441 +1556 4 29.0109 14.3064 31.825 -10.272 37.9041 18.9788 +1557 6 1.13952 22.1955 33.6303 -59.4889 25.247 28.7943 +1558 4 0.675447 22.8098 33.0333 5.4615 -9.68619 7.91413 +1559 4 1.8611 21.9185 33.1521 52.5767 -22.4691 -40.0321 +1560 6 17.4529 16.8222 9.92046 -20.0761 -24.0842 48.1247 +1561 4 17.9341 17.1517 9.19999 21.5054 13.464 -32.8219 +1562 4 17.9802 16.1035 10.3295 -2.40424 8.44812 -14.2536 +1563 6 18.74 29.8021 14.3918 16.1488 4.65404 69.9188 +1564 4 19.5966 29.6355 14.8679 -24.5899 1.22938 -11.6521 +1565 4 18.9027 29.6655 13.4911 13.4763 -5.12933 -46.2854 +1566 6 39.4106 6.51176 13.0171 8.18439 9.54271 -9.98348 +1567 4 39.7968 7.3217 12.6105 -7.82756 -18.4389 5.68309 +1568 4 39.8965 5.76959 12.6221 -1.11983 7.69721 6.02388 +1569 6 54.1122 38.2735 14.316 -26.3921 15.7841 23.5556 +1570 4 53.5092 38.7211 14.9446 14.1224 -15.8084 0.476194 +1571 4 53.7657 38.6747 13.5269 5.67525 0.359642 -25.5906 +1572 6 7.51656 32.0218 20.9281 34.7748 10.0158 34.1931 +1573 4 7.08362 31.9253 20.1193 -22.6959 2.07513 -43.8223 +1574 4 7.03544 31.4175 21.4603 -12.2713 -14.4046 24.4342 +1575 6 26.9722 15.5137 13.836 8.2831 -9.07996 -12.1546 +1576 4 27.2905 14.6773 14.2204 -10.3825 7.39938 7.42218 +1577 4 26.0228 15.629 13.9568 -6.27371 -3.74993 11.5294 +1578 6 18.3731 16.4369 32.1258 -5.47484 6.15837 -16.1574 +1579 4 18.1737 16.7054 31.2071 -0.945967 -8.38127 9.44724 +1580 4 19.0036 17.0959 32.4159 12.6478 4.85619 3.13766 +1581 6 52.4904 31.6749 23.2282 -45.8236 3.94874 65.5164 +1582 4 52.5054 32.2301 24.055 -6.11863 -14.7847 -21.5508 +1583 4 53.2278 31.9578 22.7624 44.676 11.2926 -39.5338 +1584 6 2.17063 9.69676 28.2025 -10.599 22.0242 17.0864 +1585 4 2.41083 10.574 27.888 12.6445 -0.15763 -12.1006 +1586 4 1.36653 9.91172 28.7063 1.66945 -10.1846 4.32482 +1587 6 32.9295 0.084333 22.579 -26.8721 -17.4052 -13.8633 +1588 4 33.2309 41.109 22.2818 0.690852 17.8844 8.89147 +1589 4 33.6446 0.598803 22.932 23.7791 -0.031599 0.0852179 +1590 6 20.7171 41.5453 38.643 51.9522 19.855 -62.1487 +1591 4 20.0643 41.0408 39.0691 -29.2365 -22.9372 13.5286 +1592 4 20.9788 41.0468 37.7869 -12.0924 18.2625 49.3819 +1593 6 43.2965 24.3242 12.1559 29.4143 27.7167 -28.3716 +1594 4 43.2964 25.2918 12.2975 -10.3211 -14.9579 7.88207 +1595 4 44.0244 24.2792 11.4826 -12.2932 -11.2644 22.4039 +1596 6 22.0333 36.2992 11.8143 -17.8744 11.1706 -5.23693 +1597 4 21.6038 36.9407 11.2131 12.0614 -9.84488 11.7859 +1598 4 22.8639 36.0559 11.3996 4.49067 -2.6397 -1.6843 +1599 6 50.7446 20.5307 30.3299 -19.4296 24.1009 0.394401 +1600 4 50.3769 20.0585 31.0978 -4.60399 -0.499453 -6.82258 +1601 4 50.1204 21.2977 30.1594 19.9431 -26.9935 4.34337 +1602 6 20.8379 3.84934 18.1872 -10.63 2.24574 17.9634 +1603 4 21.6372 4.15439 17.7675 6.81748 4.13844 -2.44268 +1604 4 20.7537 4.31685 19.0447 1.53322 -4.30004 -12.0579 +1605 6 4.001 20.6421 6.99361 -18.7611 -9.71733 3.72301 +1606 4 3.09723 20.6004 6.53941 30.5715 -8.65918 22.3858 +1607 4 4.00786 20.2035 7.89591 -15.2068 14.2544 -28.772 +1608 6 11.948 15.4413 41.4409 9.86263 -45.3449 -5.39948 +1609 4 11.9713 14.4541 41.6361 -2.32711 35.624 3.02695 +1610 4 12.4708 15.4889 40.6181 -5.28805 11.0492 6.42 +1611 6 3.00764 18.5435 38.9252 6.90717 -29.584 40.0663 +1612 4 3.56523 17.7255 38.8717 -9.75827 16.9893 -1.25399 +1613 4 2.92934 18.9138 38.0721 -1.66709 15.3109 -35.9518 +1614 6 8.5978 38.8858 11.3072 48.4025 32.5603 4.46589 +1615 4 9.44036 39.0024 10.7943 -20.5341 -1.07382 9.55064 +1616 4 8.19448 38.1327 10.9484 -22.3544 -46.6733 -17.9601 +1617 6 12.9691 33.9778 38.4933 34.8069 -13.3685 -21.4899 +1618 4 12.6573 33.2385 37.9471 -9.06758 1.22663 10.2849 +1619 4 13.9307 33.983 38.2659 -20.4066 10.3952 14.8996 +1620 6 4.69069 11.9902 6.04709 5.57568 0.955193 2.63183 +1621 4 3.83092 11.6207 5.79405 1.19943 -2.71585 -3.65246 +1622 4 5.36696 11.7708 5.36999 -19.9658 -4.94035 2.87891 +1623 6 10.8381 15.9154 25.2196 -36.4648 2.02786 -4.38258 +1624 4 11.7191 16.2167 25.3262 31.8449 11.9168 5.4517 +1625 4 10.3518 16.6682 24.8476 5.65772 -8.76316 -0.529027 +1626 6 20.7604 3.23767 6.55488 4.15603 28.9608 0.670607 +1627 4 20.2106 2.56517 6.18958 -7.79877 -24.0058 -5.45951 +1628 4 20.2434 4.04703 6.45055 -2.36445 1.41903 2.77062 +1629 6 47.6381 39.1588 31.2153 -11.506 28.7103 -40.9212 +1630 4 46.7125 39.0803 30.8864 16.1685 3.01672 12.9065 +1631 4 48.0161 39.883 30.6238 -10.851 -36.2784 24.6994 +1632 6 8.33868 27.7571 27.6932 -33.938 3.65348 13.4266 +1633 4 7.90796 26.9962 28.1436 6.90464 18.5991 -0.450451 +1634 4 9.05762 27.3551 27.2376 19.8804 -10.068 -12.1598 +1635 6 33.245 40.3099 33.4253 18.3517 22.2199 -28.9554 +1636 4 32.5937 41.0038 33.2194 0.94932 -12.4457 9.89811 +1637 4 33.9479 40.492 32.7526 -7.59275 -9.33057 17.0692 +1638 6 24.5058 34.6327 27.2588 -1.70215 14.4876 -27.3243 +1639 4 24.8356 35.5409 27.0166 -5.53884 -24.0927 13.0812 +1640 4 24.1351 34.315 26.3934 7.47117 3.95694 29.9195 +1641 6 13.3256 36.76 35.7403 23.371 22.3884 -21.319 +1642 4 14.292 36.6204 35.8687 -19.0607 -2.42845 14.454 +1643 4 12.8134 36.0651 36.1242 -8.79549 -23.1532 9.33092 +1644 6 34.0568 20.1616 33.2139 18.2744 1.49148 -3.34215 +1645 4 34.901 20.3965 32.7524 -27.9907 10.0382 9.43414 +1646 4 33.5726 20.9405 33.5892 13.555 -8.0917 -8.63642 +1647 6 22.8329 33.5616 31.6214 -12.6844 15.5573 -21.5595 +1648 4 23.5755 34.1858 31.5969 1.53708 -3.14405 -0.637663 +1649 4 23.0292 32.8658 32.2325 13.4469 -12.4025 17.113 +1650 6 23.7434 2.42786 19.8498 9.49596 22.5629 12.9133 +1651 4 24.532 1.90722 19.7117 15.1933 -8.07802 -2.32773 +1652 4 23.0629 1.99408 19.3682 -23.4605 -15.8437 -14.4607 +1653 6 10.59 1.63974 20.5169 -0.95575 -6.83071 6.14558 +1654 4 9.98705 1.03236 20.0473 7.71399 2.84727 3.14747 +1655 4 10.6246 2.47233 20.0276 -8.35822 1.7372 -3.87231 +1656 6 6.50082 24.8628 7.81243 5.63459 3.09475 -4.38693 +1657 4 7.40706 24.9537 7.44087 -14.825 -10.0154 1.3351 +1658 4 6.01351 24.1359 7.38457 10.3118 5.93376 -6.27471 +1659 6 54.7907 32.5298 25.4601 2.42441 14.1538 -12.299 +1660 4 54.0693 33.194 25.3949 12.697 -15.3913 -0.923548 +1661 4 0.387469 32.6052 24.6546 -22.4501 -0.197402 25.3904 +1662 6 6.24565 20.1804 28.9699 -20.0835 16.2671 13.5362 +1663 4 5.37616 20.2206 28.5173 17.3942 -4.89439 1.50138 +1664 4 6.85708 19.7029 28.4106 5.94408 -11.9876 -6.03836 +1665 6 50.061 21.6087 11.3404 -11.515 44.0552 -42.0488 +1666 4 50.9725 21.751 11.0493 2.56545 -3.3262 -1.97817 +1667 4 50.0662 20.9568 11.9903 8.13397 -42.2403 36.0281 +1668 6 43.4741 33.5215 19.648 39.1267 -7.16957 -40.9914 +1669 4 43.8052 33.5504 20.5247 -1.27694 2.64583 28.8889 +1670 4 42.5461 33.5822 19.6063 -36.855 5.29583 12.3512 +1671 6 30.8225 7.19458 41.0729 -33.0718 18.8928 10.1641 +1672 4 30.0173 7.64992 40.6345 32.3343 -18.9847 22.962 +1673 4 30.7853 7.47469 0.131591 -1.52838 -8.42988 -38.7943 +1674 6 12.1264 25.8478 11.0965 -41.5825 -1.76886 -24.0951 +1675 4 11.2804 25.9828 10.5746 22.2453 -8.09118 27.7312 +1676 4 12.6111 26.6214 10.8799 25.9351 22.819 -1.42381 +1677 6 47.8207 5.82713 17.7363 28.7614 -16.7343 -8.46055 +1678 4 48.0335 5.15295 17.0353 -2.74159 24.5551 13.4979 +1679 4 48.6986 6.12754 18.0988 -19.3132 -4.26463 -8.98138 +1680 6 35.1697 12.9074 16.5814 -26.6969 23.1645 14.7724 +1681 4 35.331 12.9801 17.5341 9.94288 -5.95548 -5.31324 +1682 4 34.5116 13.6489 16.4838 18.7069 -22.8028 -11.189 +1683 6 10.4746 10.6344 33.9856 -30.1195 -20.4446 -6.31426 +1684 4 10.7944 11.3866 34.5009 -4.55531 -6.56386 0.452866 +1685 4 9.59186 10.377 34.349 25.6427 10.4215 -3.60637 +1686 6 9.86976 7.46809 9.66723 13.2706 -15.2427 -11.6817 +1687 4 9.07254 8.00079 9.6953 0.322066 10.4083 -1.78771 +1688 4 10.1027 7.29929 8.72005 -15.6005 8.2826 19.6359 +1689 6 11.1498 9.5629 29.1446 -4.60031 -6.3451 3.75047 +1690 4 10.6862 9.26798 29.9509 5.10767 2.07156 -10.4371 +1691 4 11.3249 8.76682 28.6116 2.75639 0.845127 6.4689 +1692 6 46.3982 12.7571 37.8973 13.0728 8.65129 -14.0384 +1693 4 46.6651 13.0033 36.9771 -6.5436 -6.98702 17.4091 +1694 4 46.8422 13.384 38.4935 -4.33131 -5.25976 0.421567 +1695 6 4.7745 19.0249 15.9997 -22.3762 2.96494 22.3523 +1696 4 4.16029 19.0173 16.7572 4.82074 7.85299 -8.34635 +1697 4 5.51792 18.5695 16.4006 17.242 -3.98645 -13.636 +1698 6 50.2756 39.8187 19.3535 -48.7732 -19.7782 -8.19609 +1699 4 50.1357 39.0812 19.9713 14.3147 6.83039 4.1366 +1700 4 49.4547 39.7468 18.7938 35.5854 8.27631 5.22634 +1701 6 3.57022 23.2982 26.3116 -7.21736 12.7853 -4.33091 +1702 4 3.04677 23.327 25.4841 2.15403 -9.28995 15.8001 +1703 4 3.1589 23.9918 26.8774 3.27351 -16.4313 -7.87876 +1704 6 43.3323 18.2357 20.5099 -9.76971 -1.121 -6.56922 +1705 4 42.7632 18.9863 20.7177 2.34101 2.93749 0.115163 +1706 4 43.9096 18.122 21.2711 1.48233 -4.92166 7.17918 +1707 6 14.4939 41.5272 19.7194 7.33174 -3.95938 -8.98841 +1708 4 13.9791 41.768 20.4704 -25.804 7.49044 14.4407 +1709 4 15.35 41.4773 20.1189 24.9681 -5.23262 -6.74673 +1710 6 29.2751 29.8624 26.915 55.5011 14.3278 -64.7852 +1711 4 29.462 29.6739 25.9095 -28.0317 9.76644 54.5148 +1712 4 30.1137 30.3565 27.1616 -29.5885 -20.0698 8.89328 +1713 6 6.32585 26.1455 11.5441 3.18215 15.5722 27.8672 +1714 4 6.22913 25.7559 12.4173 -5.87839 -9.43723 6.04013 +1715 4 6.88652 26.9071 11.7431 3.72153 0.148286 -16.8953 +1716 6 27.6581 9.23325 15.2376 24.6795 20.4415 1.81178 +1717 4 28.3906 9.86787 14.9946 -20.7277 -22.2866 6.02651 +1718 4 27.7257 8.49599 14.6233 3.42822 -3.8556 -2.27597 +1719 6 29.7826 38.0629 17.0951 -21.7625 -1.10982 -31.3954 +1720 4 29.5447 37.2807 16.5438 11.5646 7.7876 16.1146 +1721 4 29.1666 38.7512 16.7768 9.10566 -6.75007 12.2127 +1722 6 52.2237 28.7307 4.26632 40.7154 12.5569 -19.536 +1723 4 53.094 28.6942 3.75761 -25.982 6.02481 23.1744 +1724 4 51.8384 27.8718 4.17524 -3.40498 -27.0863 -4.04919 +1725 6 17.1651 16.6761 6.10093 10.0081 29.999 -15.4838 +1726 4 17.0645 17.5224 6.60658 -3.46995 -23.4179 -4.25622 +1727 4 16.9429 15.9406 6.65512 -3.52922 -13.7209 19.1007 +1728 6 36.6584 7.55275 33.426 1.51046 -27.4434 34.6673 +1729 4 36.0562 7.00422 33.9909 9.38132 12.247 -13.9906 +1730 4 36.0891 7.78594 32.7139 -15.8398 12.8789 -25.2624 +1731 6 26.1693 3.13272 9.58463 26.4836 36.1065 -53.3475 +1732 4 26.5189 3.61335 10.3026 12.8321 10.8542 33.1136 +1733 4 25.6805 2.43597 9.90138 -37.6231 -51.1462 30.1839 +1734 6 1.19232 17.1076 33.1734 0.722887 26.1228 -9.87087 +1735 4 1.0219 17.7977 32.4875 3.44775 -13.3597 11.6369 +1736 4 0.89275 17.4757 34.0242 -0.842403 -4.58413 -3.86686 +1737 6 29.175 10.1805 5.37687 2.48705 -7.47299 -1.58449 +1738 4 28.5307 10.3443 6.0806 2.54341 -1.49901 -0.102048 +1739 4 29.6529 9.35261 5.56356 -13.9845 3.47491 -0.693848 +1740 6 9.21964 21.135 0.193729 30.6013 -8.57211 -16.2038 +1741 4 9.93935 20.7152 41.5745 -5.21063 7.9265 20.924 +1742 4 8.4582 20.7874 41.6647 -18.4316 -1.36421 1.54976 +1743 6 7.41915 26.897 34.8578 6.273 24.0322 40.4596 +1744 4 7.07209 27.1094 35.7714 11.2799 -9.18849 -34.7736 +1745 4 6.87885 26.1925 34.5434 -18.5272 -22.724 -11.5995 +1746 6 18.6237 10.1563 3.02822 -55.9716 37.9013 1.68891 +1747 4 17.9823 9.44023 2.87563 14.9297 4.34306 1.98909 +1748 4 18.009 10.9755 3.18254 40.8652 -32.8317 -2.61569 +1749 6 13.1455 21.2337 25.2154 -14.3081 5.93545 -14.9534 +1750 4 12.8153 21.6822 24.4216 9.6722 -4.26313 4.93127 +1751 4 12.7862 20.3541 25.1726 -3.49479 -14.4912 -0.313259 +1752 6 4.91031 24.4198 40.532 -13.7809 -26.5024 -53.169 +1753 4 5.65778 24.4539 41.0894 26.3299 12.2697 26.6549 +1754 4 5.26856 23.9753 39.7091 -18.4358 16.5303 24.5031 +1755 6 54.7198 6.2862 9.93073 18.558 2.67796 -18.7732 +1756 4 54.1336 6.00192 10.611 -15.308 -5.80798 23.6242 +1757 4 0.005563 7.17106 10.1764 0.43073 7.36928 5.10877 +1758 6 51.7604 16.6436 19.3877 -20.3234 -7.55047 -14.8495 +1759 4 51.6779 16.1639 18.5383 1.1676 14.9854 4.84802 +1760 4 52.2077 17.4816 19.2574 16.3674 3.30585 -9.00164 +1761 6 38.6218 2.96001 13.0988 15.7387 3.67705 55.5859 +1762 4 38.6299 3.43096 13.9849 -4.06073 -12.9308 -23.724 +1763 4 38.2169 3.56793 12.5083 -12.8186 19.7945 -24.9943 +1764 6 19.4471 35.7007 9.61167 2.35324 -8.95281 6.35471 +1765 4 18.8335 36.2871 9.19379 -17.9936 2.63552 -14.7984 +1766 4 18.9495 35.3837 10.3842 8.56204 6.47345 -9.11173 +1767 6 46.9457 37.6212 25.7021 -15.6754 4.57489 10.5165 +1768 4 47.0239 38.0262 24.8354 11.6036 -0.197794 -10.4287 +1769 4 47.7281 37.1166 25.9279 8.14222 -0.129186 -6.11913 +1770 6 20.0249 17.2708 14.7582 9.34392 -2.11639 -6.02108 +1771 4 19.1723 17.4786 15.1706 12.7461 -0.873648 3.80655 +1772 4 20.7009 17.0069 15.4035 -13.3418 2.74043 0.572405 +1773 6 24.7358 29.2923 3.78206 18.5642 -33.4808 -47.1325 +1774 4 24.7422 28.3915 3.3709 -13.1038 11.8323 28.3161 +1775 4 25.3506 29.6775 3.14782 -2.77927 21.1078 10.4189 +1776 6 3.43141 8.92567 6.82668 25.8011 -1.75535 29.9445 +1777 4 3.08486 8.82716 7.75964 16.0017 4.22665 -30.6726 +1778 4 4.42441 9.10783 6.89545 -42.5611 -5.30748 1.54274 +1779 6 17.4891 30.59 19.7026 37.1524 -11.5388 -6.241 +1780 4 18.4343 30.3591 19.4199 -38.2372 10.1448 10.4771 +1781 4 16.9657 29.7875 19.5831 -4.14236 3.18225 -9.29444 +1782 6 13.2748 16.1833 39.0603 8.39615 -10.6604 2.01333 +1783 4 13.778 16.9491 39.3364 8.93523 3.59341 7.63718 +1784 4 12.5498 16.5465 38.5646 -17.693 7.52452 -10.3405 +1785 6 23.8419 27.9652 11.5971 -29.0622 15.8949 5.8355 +1786 4 23.0433 27.5239 11.9581 15.8216 -1.64981 -8.50246 +1787 4 23.6687 28.8945 11.8451 9.38175 -9.8305 -3.59643 +1788 6 14.4582 24.411 21.2251 -13.2323 27.0215 19.0701 +1789 4 13.9163 25.2229 21.3861 13.2503 -9.35589 -12.2275 +1790 4 14.348 23.9323 22.0593 -1.27999 -3.95586 -5.82862 +1791 6 46.6209 15.1404 22.2877 -21.0909 8.30909 34.5316 +1792 4 45.8336 14.7024 21.9608 7.3328 -3.88381 -14.3297 +1793 4 47.2246 15.4169 21.6106 10.5055 -5.27886 -22.0515 +1794 6 19.1453 29.7169 11.8746 -27.0123 -18.8736 -35.9167 +1795 4 18.7667 30.5363 11.5796 10.8323 29.6783 4.39578 +1796 4 18.5214 29.1838 11.3275 23.3568 -13.7991 20.8336 +1797 6 36.9132 18.8016 27.615 -17.0652 -23.8487 30.8874 +1798 4 36.4034 18.4868 26.8464 6.26881 1.65463 6.80847 +1799 4 36.6041 18.1666 28.3506 10.215 31.7365 -33.4968 +1800 6 35.8839 17.5137 25.5036 -5.81764 30.7264 -16.7466 +1801 4 36.5665 17.9094 24.9 -10.7703 -22.5287 9.19997 +1802 4 35.9135 16.5474 25.44 8.68204 5.15754 -2.43364 +1803 6 8.04468 41.8981 31.5366 26.4021 9.77217 -3.38911 +1804 4 8.66886 41.284 31.9946 -24.4733 15.0027 -13.0466 +1805 4 8.60227 0.704634 31.1522 -11.4596 -14.2431 6.13083 +1806 6 31.7024 34.8356 17.9299 26.5575 -27.0845 -4.88708 +1807 4 32.6196 34.4986 17.7931 -22.3662 0.836155 -3.84042 +1808 4 31.9071 35.6664 18.3392 -5.09232 26.8034 6.09861 +1809 6 22.0993 41.0535 5.13739 10.0927 40.3608 -89.4928 +1810 4 22.1435 40.6782 5.94278 2.96748 -46.7441 88.004 +1811 4 22.8097 40.6452 4.60918 -8.49191 2.25551 6.5005 +1812 6 11.6188 5.17183 29.5438 -37.4391 -17.3681 45.4318 +1813 4 12.0782 4.3477 29.7115 12.4576 1.56532 -11.0695 +1814 4 10.8376 5.06958 30.1835 21.3256 14.0691 -33.8944 +1815 6 13.0142 9.45267 21.0738 -17.3871 -39.5803 -33.4019 +1816 4 13.648 9.91302 21.5572 37.1542 33.3127 26.6408 +1817 4 13.4951 8.71823 20.6397 -14.9934 11.5246 2.17133 +1818 6 12.4259 4.16416 0.171584 25.5917 58.0572 -18.9009 +1819 4 12.7038 3.75631 0.988868 -0.121161 -3.62646 8.37405 +1820 4 12.9914 5.02921 0.073462 -27.1162 -49.1387 2.0493 +1821 6 45.1548 14.6294 28.1056 43.5869 -15.7342 -2.79686 +1822 4 45.3799 14.9442 27.2254 -14.4652 2.82802 -6.08545 +1823 4 46.001 14.1543 28.294 -26.1128 6.03561 5.66217 +1824 6 52.5819 19.2522 0.880939 -13.6546 -24.4625 3.21793 +1825 4 52.4967 19.3157 41.8353 6.16951 -6.72877 -2.3034 +1826 4 52.7342 20.1258 1.1855 8.55196 28.2584 6.16427 +1827 6 0.17636 18.5769 30.5692 -13.5341 -21.3209 11.3545 +1828 4 0.97347 18.6538 30.0344 3.16555 8.74201 -0.550561 +1829 4 54.7381 19.4288 30.6755 1.51483 11.9419 -1.05075 +1830 6 17.6474 28.1849 1.96582 -3.95698 7.79984 2.09024 +1831 4 17.0036 28.8884 1.72628 7.01161 -11.1903 7.18073 +1832 4 17.5665 28.0879 2.93205 1.48476 5.36119 -8.9874 +1833 6 22.5179 30.1562 5.01973 -0.557011 13.5756 -11.2394 +1834 4 23.053 30.1464 4.21842 7.71181 1.56353 5.86697 +1835 4 22.1417 29.2826 4.9966 -11.5089 -8.75783 6.0437 +1836 6 11.3992 8.80614 17.6425 18.8049 17.2909 -5.92301 +1837 4 12.0044 8.1818 18.0403 -8.94801 -14.7479 17.6102 +1838 4 12.0653 9.44286 17.3244 -18.8797 1.15675 -4.46111 +1839 6 32.2825 3.5901 26.8335 38.6865 42.7422 0.354813 +1840 4 31.9744 3.38447 25.9652 -16.937 -9.17442 -22.5821 +1841 4 32.8531 4.41036 26.697 -18.7333 -32.0278 -1.10411 +1842 6 26.8283 37.1448 15.664 9.9544 44.9512 -6.81835 +1843 4 26.832 37.6522 16.5019 -4.80771 -22.2764 -7.00776 +1844 4 26.708 36.2069 15.7377 -4.77442 -21.1488 11.5765 +1845 6 22.9466 3.40402 22.281 26.551 -3.46013 -1.27592 +1846 4 23.3626 3.00539 21.4748 -15.0613 6.75 14.6032 +1847 4 23.702 3.67884 22.8406 -14.5661 -4.86975 -12.1571 +1848 6 14.6187 28.2219 5.2011 12.2375 -1.31522 5.54773 +1849 4 14.146 28.1316 4.37141 -5.71124 1.87741 -8.30492 +1850 4 14.2863 29.0052 5.66137 -0.824291 -0.470469 -2.06805 +1851 6 20.2555 37.1856 16.5486 -24.9193 16.4856 21.7008 +1852 4 21.0596 37.4718 16.144 26.6499 6.5165 -11.4453 +1853 4 20.1477 37.8155 17.2956 -4.48599 -12.7862 -6.90992 +1854 6 17.9469 28.5629 23.8891 26.0841 -15.2841 -12.8531 +1855 4 18.7956 28.2639 23.4837 -20.5944 5.95667 14.8805 +1856 4 17.3322 27.8283 23.7208 -3.07308 9.52654 -1.59768 +1857 6 33.6454 24.2344 25.2281 6.08515 -19.3492 9.67379 +1858 4 33.7229 23.2583 25.1621 -7.7165 13.5894 -11.682 +1859 4 33.9838 24.3464 26.1231 0.527101 9.69022 -3.14208 +1860 6 9.99248 17.6305 2.22889 -2.94775 -31.1618 -12.577 +1861 4 10.7668 17.5307 1.6348 -7.17319 1.58445 12.7603 +1862 4 9.8062 16.7546 2.64219 6.61617 15.6433 -4.64734 +1863 6 24.3378 36.7975 8.92134 10.0949 -17.5556 18.6285 +1864 4 24.0798 37.5812 8.46711 -7.4438 24.0622 -5.98172 +1865 4 24.7733 37.0584 9.7453 -6.84359 -4.10885 -5.58351 +1866 6 14.3929 4.30304 27.7402 56.7365 -3.53996 19.7179 +1867 4 15.3546 4.44499 27.4586 -37.3153 -7.57895 7.00929 +1868 4 13.8272 4.37832 26.9899 -16.116 5.01688 -19.8092 +1869 6 13.2096 25.4586 35.3298 -3.87145 -6.51473 -10.8119 +1870 4 13.1476 25.2267 36.278 -1.83966 -3.78777 -13.8323 +1871 4 12.5545 24.9939 34.7684 5.09589 5.85633 19.2997 +1872 6 43.7315 33.1816 24.4051 17.2004 -9.02075 24.8986 +1873 4 44.3591 33.0681 25.1678 -20.1541 -6.26738 -17.3644 +1874 4 44.1096 33.9146 23.9227 -1.6352 8.32092 -8.69406 +1875 6 6.97009 30.4077 7.13769 23.121 1.43384 34.0809 +1876 4 6.71282 29.9591 7.9596 7.06976 3.62274 -2.26904 +1877 4 6.20421 30.2819 6.61977 -27.9511 -2.76807 -27.2062 +1878 6 44.437 39.4145 21.7835 -9.43682 11.6365 -18.5611 +1879 4 43.878 39.1032 21.0489 1.92512 -11.9494 17.5009 +1880 4 44.878 40.1639 21.3648 8.44417 -6.89071 6.17346 +1881 6 1.1648 16.4475 24.9778 -2.61131 5.39938 13.1681 +1882 4 1.07525 17.0286 24.1819 -7.88043 -13.0173 22.3573 +1883 4 0.434843 16.5677 25.6378 18.4556 1.9359 -28.7216 +1884 6 8.16988 33.8361 10.6637 16.6829 23.9256 47.7562 +1885 4 8.49559 33.5478 9.83195 -4.50358 -22.2449 -29.7436 +1886 4 7.35799 33.4028 10.9227 -18.4601 -13.1254 -8.86092 +1887 6 45.3716 15.8699 40.491 -6.36942 -3.03704 -2.15917 +1888 4 44.5133 15.7719 40.0601 4.63234 -6.98635 -0.416374 +1889 4 45.243 16.6248 41.0649 5.7116 1.92459 5.42472 +1890 6 38.7776 4.29245 15.9056 11.0795 0.30753 4.41463 +1891 4 39.6766 4.00679 16.0952 1.69097 -2.92337 -3.33067 +1892 4 38.5504 4.73291 16.7401 -7.14778 -2.92142 -9.36231 +1893 6 21.0846 9.20759 23.9691 5.60032 -0.18462 4.18544 +1894 4 20.9445 8.65571 23.1711 -3.69603 16.8592 7.46004 +1895 4 20.5672 10.0363 23.9442 1.93643 -14.5945 -11.3561 +1896 6 6.46938 36.1391 20.0069 4.0004 4.10087 4.13062 +1897 4 5.99357 35.3124 19.8297 -2.3473 7.0562 -2.30419 +1898 4 7.3052 35.893 20.4098 -0.600933 -5.92452 -3.30983 +1899 6 17.7588 23.4635 11.2444 16.528 -28.2646 53.7307 +1900 4 16.9432 23.8548 11.0264 -32.805 26.4079 -23.7501 +1901 4 17.621 23.3206 12.2167 9.32529 -0.814156 -28.2078 +1902 6 2.23938 39.2705 23.5372 32.4488 -19.3396 -21.3039 +1903 4 2.96143 39.1072 24.212 -19.8533 -4.03587 -26.9428 +1904 4 2.57592 39.0525 22.6024 -11.4643 11.6849 46.2914 +1905 6 21.7189 10.3135 3.08585 -2.90529 19.7604 61.578 +1906 4 21.843 10.1221 2.19424 -0.974385 -17.6276 -55.1642 +1907 4 20.7734 10.4085 3.28686 2.80557 -4.86174 -11.6796 +1908 6 13.3371 37.6485 26.8148 34.7445 -2.08205 -3.58175 +1909 4 12.7942 37.01 27.2655 -5.666 -15.7112 8.11946 +1910 4 14.1995 37.1812 26.5945 -31.1056 12.6209 6.4215 +1911 6 45.679 9.86525 8.82671 -1.22844 -5.97168 -0.0165319 +1912 4 45.3204 9.57969 7.98479 1.29945 7.51218 -9.52666 +1913 4 45.2548 9.27624 9.44517 -6.37871 -3.09075 9.62419 +1914 6 39.8117 32.343 29.5858 -3.04799 14.0722 -9.88422 +1915 4 39.6223 31.4471 29.2796 3.58631 -7.81261 7.71305 +1916 4 40.3439 32.3214 30.3816 0.770365 -10.1242 2.16071 +1917 6 39.1301 32.1592 8.96473 45.9624 -7.76569 -23.2306 +1918 4 39.6852 32.0596 8.1252 -31.4186 4.60772 35.1501 +1919 4 38.2007 32.2042 8.75798 -9.66602 0.778467 -8.76952 +1920 6 29.7501 11.3103 40.3404 42.6438 -12.6008 -10.1865 +1921 4 29.0692 10.6634 40.5326 -1.99158 -8.72077 -0.363163 +1922 4 30.6164 10.7842 40.3158 -34.6338 15.486 -0.0451708 +1923 6 24.8345 19.8801 29.8412 -7.59088 37.7695 16.0848 +1924 4 24.9026 19.0378 30.268 -1.65451 -21.4471 9.48031 +1925 4 24.5694 20.5293 30.547 8.64688 -23.6335 -15.2845 +1926 6 50.0799 29.4689 2.86832 11.3398 7.37373 -14.0975 +1927 4 50.7937 29.3382 3.51213 -5.95266 6.62042 -8.33887 +1928 4 50.5172 29.4209 1.98721 -16.9062 -3.16045 21.5768 +1929 6 26.3158 13.2487 37.9516 44.6834 6.62304 1.7852 +1930 4 27.2667 13.2121 37.7291 -19.4356 -10.4808 -19.3263 +1931 4 26.4654 13.336 38.8817 -25.2145 10.5198 25.1195 +1932 6 24.3285 13.817 16.1492 -2.87417 -29.0242 -9.8062 +1933 4 24.8278 14.0306 16.9324 2.95884 13.8503 11.1204 +1934 4 24.1796 14.5912 15.6032 1.91347 13.6823 2.96602 +1935 6 21.9624 25.0824 8.00452 15.4008 12.078 14.6814 +1936 4 22.598 25.7039 7.58094 -6.50256 -15.9793 3.04336 +1937 4 22.4506 24.6482 8.74092 -7.92214 9.81208 -17.5113 +1938 6 50.1646 25.295 29.0323 7.20414 -13.325 -13.2678 +1939 4 50.9752 25.188 28.522 -3.46618 -9.57224 -11.582 +1940 4 50.4808 25.9292 29.6536 -4.58067 20.151 23.6328 +1941 6 23.186 6.81871 7.63171 8.52809 43.4321 -4.70249 +1942 4 24.005 7.36604 7.81791 -26.2659 -19.6382 -4.15731 +1943 4 22.4749 7.49932 7.50679 12.9101 -23.886 0.0924589 +1944 6 6.93738 5.85096 20.8328 -1.25739 23.0019 -5.42089 +1945 4 7.49016 6.65136 20.6793 -8.05782 -22.0664 2.33926 +1946 4 6.43567 5.73489 20.0135 6.68134 -11.6114 -0.0369962 +1947 6 25.4027 39.7503 23.9523 -6.31967 32.2782 -31.5462 +1948 4 25.6215 38.8259 24.0292 3.86532 -10.8289 -5.32001 +1949 4 25.5293 40.0494 22.9984 1.78505 -20.5244 33.6821 +1950 6 10.8465 30.682 2.12076 -14.9417 -4.95607 29.3443 +1951 4 9.91334 30.8811 2.27771 3.65307 -4.25506 9.47201 +1952 4 11.0492 31.2188 1.38489 10.4343 12.2811 -36.8692 +1953 6 23.0846 40.5263 40.0577 -14.1833 12.856 -13.2149 +1954 4 23.7732 40.7716 39.4116 -4.4893 -4.99974 3.24897 +1955 4 22.2685 41.0049 39.7737 14.5189 -12.3092 -2.05606 +1956 6 29.2062 28.3669 37.5673 -46.9973 46.4688 -26.4511 +1957 4 28.2092 28.447 37.3765 47.4284 -5.55714 9.99444 +1958 4 29.3363 27.5265 37.9547 9.31284 -31.0764 15.334 +1959 6 1.86163 12.1711 18.0765 -5.91003 5.49035 -5.71632 +1960 4 2.55659 11.9166 18.6527 25.6221 -14.4574 8.12849 +1961 4 1.26079 12.5379 18.7153 -20.6967 6.08864 -3.03965 +1962 6 35.8475 14.1052 8.57203 -21.6385 -0.893463 -33.3774 +1963 4 35.1968 13.4152 8.63145 -9.00219 -13.9675 31.2536 +1964 4 35.5915 14.3843 7.67264 23.8052 12.2531 2.11843 +1965 6 9.47935 39.8135 37.5891 59.0759 6.31763 -30.1219 +1966 4 10.4266 39.6693 37.2666 -35.8633 -8.68454 26.4626 +1967 4 9.26489 40.5592 37.0217 -20.4655 -4.29881 5.22341 +1968 6 3.55142 30.3339 19.2713 -4.86381 -1.52132 15.3498 +1969 4 4.33638 30.9045 19.2209 2.57405 -7.87202 3.73908 +1970 4 3.61239 29.7873 20.0935 6.99099 14.0083 -17.3235 +1971 6 36.3358 32.3745 17.56 -88.747 -21.2483 -18.3477 +1972 4 37.1123 32.7301 17.855 71.5568 29.0637 22.2427 +1973 4 36.4955 31.7908 16.8209 7.92507 -6.87638 -5.35096 +1974 6 22.0663 24.5107 41.4102 10.2987 16.3962 12.7497 +1975 4 21.8202 25.2352 0.099599 7.35269 -2.74787 -1.24985 +1976 4 21.4331 24.5495 40.7007 -15.7672 -0.145359 -12.6123 +1977 6 45.7559 15.6146 11.6534 9.54961 -0.52573 -11.8143 +1978 4 46.6616 15.9476 11.7359 -2.85604 3.39399 3.95489 +1979 4 45.8337 14.6574 11.6049 5.18085 -12.4794 -2.56515 +1980 6 22.3677 20.3608 16.0248 -8.43349 0.762232 -3.33301 +1981 4 21.8453 20.4382 16.8206 -16.1556 -9.64869 10.2413 +1982 4 23.0114 21.0388 16.1556 20.3116 20.3082 3.24798 +1983 6 25.8272 25.7408 18.9039 -4.38174 23.1082 -8.64826 +1984 4 25.2526 26.4897 18.6396 10.1677 -11.9346 2.39614 +1985 4 25.327 25.3554 19.6213 -1.60311 -10.6753 3.35926 +1986 6 35.3217 34.2027 33.2895 -15.2368 -41.9721 4.95923 +1987 4 35.4982 35.1152 33.2737 3.10328 43.0158 -1.14622 +1988 4 34.4946 34.1251 33.8 0.780353 -3.85018 -10.6306 +1989 6 39.2773 17.1161 17.3873 -13.1248 -32.2738 -8.05101 +1990 4 39.9918 17.6798 17.5739 28.094 23.6652 8.23643 +1991 4 38.688 17.6273 16.829 -11.1713 3.07886 5.75329 +1992 6 0.390078 14.9382 21.7871 11.1367 4.76555 -0.935352 +1993 4 54.4387 14.8735 21.5807 -4.47162 2.48431 -1.07762 +1994 4 0.539841 14.2564 22.4568 -0.558284 -6.24417 -4.29591 +1995 6 15.9777 23.2264 17.7728 8.65625 13.1041 -6.34263 +1996 4 15.4566 22.9884 16.9791 5.52796 1.00784 5.82867 +1997 4 16.2806 24.159 17.6616 -10.6082 -13.1932 5.11686 +1998 6 5.23931 11.1231 17.5575 35.8701 -10.5445 17.9772 +1999 4 4.9182 10.2425 17.6538 -30.0926 -10.858 -8.95801 +2000 4 6.0864 10.9521 18.0214 -7.64643 27.0942 -5.06777 +2001 6 9.32885 36.7248 13.2722 18.9931 -22.2768 -8.23823 +2002 4 9.60165 35.7781 13.2295 -3.69965 14.6724 -0.704445 +2003 4 9.76236 37.1699 12.5317 -7.58045 -2.70049 0.515103 +2004 6 25.4778 33.5648 0.584885 -10.5355 67.2754 -12.4068 +2005 4 25.5984 34.5208 0.879361 -11.6997 -30.6233 -9.64051 +2006 4 26.086 33.1118 1.1181 20.4991 -31.2317 29.3626 +2007 6 17.3118 24.383 31.3319 -1.28664 6.54307 -2.76395 +2008 4 17.7194 25.1777 30.9449 -5.40799 -4.17061 0.343513 +2009 4 16.6541 24.6578 31.9842 -4.89885 3.77294 -0.581941 +2010 6 50.5608 32.7082 27.7934 4.54158 -2.94952 -18.7634 +2011 4 50.7453 32.9177 28.6973 0.494052 11.2961 18.8161 +2012 4 49.6536 32.9735 27.676 -15.0266 -0.0998574 -2.84245 +2013 6 2.26734 37.236 16.1173 -6.42813 -12.7591 -21.9136 +2014 4 3.23226 37.3187 16.1136 -7.03488 -2.64717 4.42174 +2015 4 1.90002 37.4962 16.9584 8.86323 8.39289 12.7736 +2016 6 25.781 33.1953 8.40059 -29.5389 -21.3471 9.61313 +2017 4 24.912 33.1588 8.86731 13.6407 4.32372 -10.5279 +2018 4 25.7521 32.4014 7.84509 3.14784 4.30114 -1.53431 +2019 6 24.7803 7.83271 25.42 33.5144 32.018 13.9598 +2020 4 25.5535 8.29724 25.0002 -28.4293 -10.6828 16.5011 +2021 4 24.3491 7.42211 24.7041 -24.9556 -17.4551 -27.4815 +2022 6 44.0168 27.3303 21.5604 -2.1935 -26.0293 -25.9567 +2023 4 43.1804 27.7287 21.7105 -15.5436 25.6402 11.6584 +2024 4 43.7182 26.5374 21.0766 16.4483 6.01939 6.04345 +2025 6 20.8314 32.075 6.72772 34.1297 -23.9008 -4.85338 +2026 4 21.613 31.4679 6.7544 -19.7741 14.5872 -14.4381 +2027 4 20.6476 32.1788 7.6576 -7.69651 14.1485 11.3249 +2028 6 0.619789 26.0994 3.99415 -10.3518 14.1264 10.767 +2029 4 0.887335 25.4928 3.30986 5.36048 -13.1936 -7.97543 +2030 4 1.24971 25.9998 4.71308 0.85353 -1.82089 -1.56654 +2031 6 23.69 0.227417 22.8544 35.0871 1.11343 17.3571 +2032 4 23.3906 1.11513 23.0752 -8.28129 -2.57498 -6.74336 +2033 4 24.6181 0.214091 23.2237 -29.0994 -2.98435 -11.3486 +2034 6 35.6339 26.9438 6.46453 10.8918 50.3879 3.14258 +2035 4 36.2586 27.0344 7.19591 -3.09793 -24.7425 -0.485193 +2036 4 35.6905 27.8753 6.10871 -13.1004 -35.3011 6.52721 +2037 6 50.1792 7.09321 18.6927 -10.3798 0.485236 0.91939 +2038 4 50.7755 7.39768 17.9917 2.23399 -7.26744 -1.07457 +2039 4 49.6856 7.89728 18.8977 2.66313 1.30029 -2.34319 +2040 6 12.4725 14.8259 12.1994 -11.4238 -12.6169 14.8051 +2041 4 11.6664 14.488 12.6556 18.5487 5.78377 -7.93059 +2042 4 12.1518 15.362 11.4889 -6.75978 6.85562 -13.2996 +2043 6 52.4644 22.357 36.3266 1.29806 9.96622 10.4358 +2044 4 51.6029 21.898 36.3064 11.3287 0.910024 -15.7837 +2045 4 53.0734 22.0059 35.6434 -17.6122 -2.36697 5.80151 +2046 6 41.7741 11.4843 39.1248 -4.39753 -8.31887 -97.8346 +2047 4 42.1028 11.6824 39.9378 27.3537 17.7413 77.2645 +2048 4 42.4804 11.7867 38.4877 -22.5072 -9.73773 16.9601 +2049 6 13.8016 22.5118 39.1095 -61.9889 -17.7515 -30.6487 +2050 4 12.8197 22.2903 39.2632 45.6803 12.2331 1.0283 +2051 4 13.898 22.318 38.1378 10.5436 5.15112 27.5343 +2052 6 28.757 19.5278 21.8422 22.1809 -34.574 6.30338 +2053 4 29.5381 18.8977 21.7155 -30.335 22.4331 6.48321 +2054 4 28.5907 19.9346 20.9925 4.65837 4.37905 -10.6157 +2055 6 8.3499 21.6369 36.3971 -4.18721 -6.14707 -6.4426 +2056 4 8.67403 22.5346 36.3601 -3.60933 11.4321 4.1017 +2057 4 7.70004 21.5677 37.1222 1.54916 7.87236 -6.53046 +2058 6 39.9526 23.9745 15.2115 13.6309 -13.3423 -31.903 +2059 4 40.8439 23.5703 15.3899 -24.3155 14.8143 -11.3375 +2060 4 39.7878 23.9253 14.2154 4.70535 3.62281 36.021 +2061 6 8.1527 38.6897 22.5283 9.69445 13.3876 41.2978 +2062 4 7.76273 39.4363 22.0797 -11.7526 5.15604 -12.9046 +2063 4 8.4358 39.1168 23.3873 -5.25998 -17.8667 -18.7912 +2064 6 10.8496 20.1728 28.9641 16.4592 -1.26099 15.6701 +2065 4 9.98954 19.7606 29.0198 -7.88942 -4.93169 1.40711 +2066 4 10.9743 20.477 28.0788 -3.54014 6.836 -18.3013 +2067 6 36.8958 23.8215 41.8184 -11.2791 50.4956 -15.8947 +2068 4 37.6092 23.2626 0.106032 31.5333 -36.7229 14.8491 +2069 4 36.0533 23.398 41.8576 -15.1401 -19.7994 6.87638 +2070 6 23.7844 40.6753 33.3645 25.4398 -8.90266 -26.6636 +2071 4 23.0047 40.9559 33.8219 -17.4738 3.31201 10.6553 +2072 4 23.8864 39.707 33.5122 -4.88896 17.7845 5.86364 +2073 6 4.67086 19.2968 35.4027 23.2175 14.2952 24.1117 +2074 4 5.52557 19.1329 35.8895 -25.1286 -0.194605 -14.6261 +2075 4 4.47498 18.5363 34.8535 5.06934 -11.7578 -4.1199 +2076 6 9.45318 25.7818 10.8943 -12.0967 -8.54473 -2.48434 +2077 4 9.17249 24.8577 10.8042 5.18757 -1.88658 7.00696 +2078 4 8.69489 26.2739 10.5541 4.04726 3.8113 4.64502 +2079 6 27.2856 22.4903 13.6084 -4.27813 -9.26261 -11.4963 +2080 4 27.1477 21.7546 14.2243 0.799228 0.372191 -1.31996 +2081 4 27.4324 22.0688 12.7356 2.14896 10.5831 15.5277 +2082 6 41.0369 18.7679 23.2817 21.3973 -17.1333 -11.6606 +2083 4 40.4805 18.1775 22.7581 -1.93352 7.79722 7.02989 +2084 4 40.5302 19.4817 23.6332 -16.07 12.1618 6.58845 +2085 6 46.4867 28.3511 20.139 19.5633 -2.73425 79.1757 +2086 4 45.7489 28.0125 20.7058 1.11057 9.83041 -23.9354 +2087 4 47.2126 28.3766 20.859 -22.6454 6.05643 -47.0217 +2088 6 14.8422 15.3983 30.0672 9.57922 -13.7488 21.5316 +2089 4 14.7114 15.4303 29.1407 -5.18406 2.12307 -31.6519 +2090 4 14.4223 14.5569 30.327 1.67929 11.6926 7.32181 +2091 6 23.5155 24.7614 35.2027 10.8097 10.1661 11.7756 +2092 4 22.8249 25.3921 35.4883 8.74662 -8.07224 -2.50931 +2093 4 24.264 24.8574 35.8273 -14.1502 1.20627 0.95778 +2094 6 19.9045 24.2066 28.4368 -7.08314 38.6572 -15.5481 +2095 4 20.1199 25.09 27.9887 -7.53461 -31.417 18.3002 +2096 4 18.948 24.2479 28.615 8.77669 -1.27719 -1.90381 +2097 6 45.9703 7.63062 20.2339 -9.12647 -14.8446 45.7383 +2098 4 46.0314 7.87281 21.2057 4.66889 -10.1155 -32.2433 +2099 4 46.2124 8.39508 19.7344 6.23892 21.3693 -9.48098 +2100 6 38.0366 12.4686 8.28298 -82.8488 23.4696 -21.0017 +2101 4 37.3097 13.1608 8.47894 48.7672 -25.4087 1.47773 +2102 4 37.4891 11.9231 7.63396 42.6716 2.94367 19.7224 +2103 6 46.9352 18.181 8.45984 -29.3266 9.95329 16.0714 +2104 4 46.1825 17.5598 8.49993 9.84889 1.25457 2.04897 +2105 4 47.3911 17.9594 7.65971 14.7535 -7.6497 -21.4463 +2106 6 10.8592 13.9727 9.37152 -3.14543 -2.30259 -2.26695 +2107 4 10.3309 14.6626 8.91794 11.6563 -8.1882 2.6931 +2108 4 11.7607 13.9013 8.99546 -12.5287 13.781 2.06755 +2109 6 34.3902 5.43491 14.0826 12.6346 -17.837 -1.14204 +2110 4 35.1666 5.80709 13.6695 9.45544 21.1547 -1.41353 +2111 4 34.3397 4.58795 13.6148 -10.7305 -5.41844 9.88093 +2112 6 0.19016 0.223418 22.9526 3.77382 -24.7853 -3.01602 +2113 4 0.21308 41.6498 22.1069 2.59646 7.80057 12.2766 +2114 4 54.882 1.08863 22.7473 -12.4607 27.7599 -7.08256 +2115 6 40.9349 30.5562 37.8906 -27.573 -19.5948 34.9696 +2116 4 40.0494 30.8463 38.2359 23.4276 0.414778 -20.0189 +2117 4 41.1198 29.7844 38.4793 13.2677 19.1991 -19.1849 +2118 6 16.6358 17.3088 12.6818 26.7235 26.3695 -9.20965 +2119 4 16.2617 16.4703 12.4231 -8.92935 -8.7699 -0.695474 +2120 4 17.0088 17.6771 11.8494 -7.35458 -7.68048 15.4997 +2121 6 29.681 5.43286 24.7605 9.99716 1.48249 -7.0405 +2122 4 30.3348 5.91815 24.2382 -0.696307 0.629534 -2.6419 +2123 4 30.0075 5.55596 25.6632 -4.07672 -1.78023 1.29455 +2124 6 49.8902 0.287541 27.2058 21.9743 -13.7053 4.20571 +2125 4 49.8511 0.519591 26.2742 -5.37584 5.48457 -4.26768 +2126 4 50.7946 41.8257 27.2858 -12.157 4.98657 1.57708 +2127 6 31.2412 31.7366 15.2127 13.4193 29.9729 -4.01619 +2128 4 31.644 30.8863 15.3566 3.05611 -13.2507 6.82249 +2129 4 31.9953 32.37 15.1128 -22.0385 -12.9049 3.52444 +2130 6 35.7903 24.1511 16.9464 13.6459 1.10276 -6.74723 +2131 4 35.6731 24.9832 16.4455 1.01595 -13.8109 1.97492 +2132 4 36.7089 23.8312 16.7527 -22.9866 2.97508 8.81266 +2133 6 24.2751 4.63968 36.7374 -16.5997 -22.3051 -33.4925 +2134 4 24.7608 5.22686 37.2962 14.6544 10.0168 10.4919 +2135 4 24.7016 4.68474 35.8573 -7.94113 -0.389021 16.9181 +2136 6 17.5636 12.9031 3.65869 27.6744 1.86844 -28.0383 +2137 4 17.6858 13.5605 2.94059 1.9993 -16.4932 11.4828 +2138 4 16.8984 13.3068 4.18363 -27.8054 1.98581 18.3397 +2139 6 4.17446 14.2934 18.2709 12.2351 -24.5699 -15.5283 +2140 4 4.25201 13.3082 18.1842 -5.45348 23.7329 4.34334 +2141 4 3.28482 14.5076 18.5604 -13.4286 -3.54266 5.37394 +2142 6 19.1793 36.8557 22.3908 -6.26797 4.12828 -2.16449 +2143 4 18.7803 36.3059 23.064 -4.74301 -7.71326 18.3965 +2144 4 19.5341 36.2254 21.7686 7.87239 -11.0625 -9.31555 +2145 6 15.659 11.9578 13.1999 9.98626 24.0921 3.91449 +2146 4 15.6233 12.8387 12.7526 3.08695 -23.3335 12.0049 +2147 4 16.532 11.8904 13.6603 -13.5492 -1.68197 -15.0215 +2148 6 24.7583 21.9129 5.36621 -52.0449 4.43235 28.4012 +2149 4 24.9756 21.6947 6.28233 10.5491 3.37037 -1.58044 +2150 4 23.7611 21.9216 5.43181 35.5612 -5.35731 -13.8865 +2151 6 52.741 18.5708 35.2268 19.1809 2.02674 5.12186 +2152 4 52.5591 18.101 34.4104 -23.468 -7.47943 -3.72799 +2153 4 51.9957 18.6447 35.8177 -20.5936 -5.49273 0.0575333 +2154 6 3.56038 27.2788 25.2921 -16.6903 -17.6792 -11.4043 +2155 4 3.96469 27.2185 26.149 7.10467 -3.13705 18.347 +2156 4 3.97939 27.9962 24.8424 10.8751 21.6711 -8.62461 +2157 6 34.4448 32.9974 30.68 48.2331 9.00339 -1.41906 +2158 4 33.5189 32.8245 30.8394 -9.09046 9.48004 8.12592 +2159 4 34.8804 33.6211 31.3233 -29.3839 -17.782 -5.29467 +2160 6 35.2611 23.7526 9.83248 5.28039 9.63542 14.9856 +2161 4 34.4624 23.9143 9.32096 3.45609 1.41047 -6.97204 +2162 4 35.624 22.9154 9.5528 3.26088 -11.8232 -8.34585 +2163 6 42.4243 15.7233 8.97763 12.8326 1.39623 12.6931 +2164 4 41.658 15.328 8.60072 -22.8346 -8.994 -22.1277 +2165 4 42.104 15.9534 9.85586 1.77226 3.68974 5.84069 +2166 6 7.76866 28.8533 32.9548 -11.0049 17.2013 -15.4709 +2167 4 8.04862 28.1203 33.4848 1.42969 -15.0059 16.0601 +2168 4 8.50079 29.0495 32.3677 8.58058 4.20069 -3.59376 +2169 6 17.6953 41.2515 36.4663 -11.3067 -18.3758 74.5383 +2170 4 16.8889 41.7296 36.6796 -1.19906 6.43806 -6.60961 +2171 4 17.8689 41.3412 35.574 12.2332 11.1792 -57.8962 +2172 6 28.5157 24.2416 15.5518 -29.4686 -13.3801 -11.1317 +2173 4 29.0166 24.9984 15.2559 10.2779 3.66755 -9.57255 +2174 4 28.1226 23.7858 14.7645 18.214 7.11075 11.8426 +2175 6 20.955 16.2999 1.15679 52.4547 14.172 -5.31351 +2176 4 20.9215 15.3848 1.33551 1.21723 -32.5558 11.4722 +2177 4 20.0795 16.5686 1.08505 -57.8144 13.7968 -3.85053 +2178 6 31.1684 40.7359 5.3086 9.60886 -48.7905 -14.3252 +2179 4 30.3201 40.4364 4.96776 -1.1434 5.1051 1.34806 +2180 4 31.1111 41.6485 5.46945 -11.8258 44.905 11.395 +2181 6 29.926 24.7744 36.4585 -3.76808 18.8348 4.26027 +2182 4 30.4252 25.4661 35.9713 -7.21832 -13.6313 5.02454 +2183 4 29.9738 23.9763 35.9568 8.68635 -20.1437 -13.5665 +2184 6 8.66863 31.0429 3.90108 5.49181 -25.3701 -11.391 +2185 4 7.74616 30.7992 3.95988 -7.56137 -0.630176 -1.16432 +2186 4 8.75287 31.8877 4.30735 2.25384 31.6916 10.4967 +2187 6 5.52708 32.7014 11.4113 -17.1068 -29.6258 4.38787 +2188 4 4.72561 33.1583 11.715 12.8879 6.23598 -5.09299 +2189 4 5.16474 31.7796 11.3163 19.6841 23.1791 1.24929 +2190 6 45.6525 35.4522 20.4433 4.50188 -15.2767 -13.8779 +2191 4 45.1533 35.403 19.6071 0.884587 3.9764 11.125 +2192 4 46.1815 34.6145 20.4501 -8.61117 18.3435 2.22997 +2193 6 19.5135 2.78077 9.78076 -23.679 -24.2198 -16.6656 +2194 4 19.3296 3.70289 9.60293 -7.62346 7.89228 3.64078 +2195 4 18.7563 2.26696 9.35595 24.4568 20.2801 14.4664 +2196 6 54.9521 9.08257 10.915 1.41457 -13.8994 3.08946 +2197 4 54.8451 8.89609 11.8656 1.69601 3.75098 -5.72792 +2198 4 0.659909 9.73404 10.7859 1.63405 2.05096 5.26063 +2199 6 21.028 26.5613 14.7909 22.3934 -16.1712 -61.6784 +2200 4 21.2545 26.1082 13.8887 -5.63248 33.4215 43.8962 +2201 4 20.0757 26.5096 14.8457 -4.66041 -4.09977 8.40724 +2202 6 14.1565 30.5187 27.5481 43.0568 3.88252 13.2649 +2203 4 14.5478 30.2647 28.4319 -11.7888 3.54471 -30.6513 +2204 4 14.9443 30.8429 27.0102 -33.9181 -6.53128 14.6047 +2205 6 29.8147 17.3367 31.0866 -27.8518 -4.92818 12.2149 +2206 4 30.6554 17.4646 30.6741 20.9401 8.7355 -10.9161 +2207 4 29.248 18.1063 30.9142 12.1966 -0.59561 3.44929 +2208 6 50.8794 17.2985 27.8251 -38.7154 2.44379 -6.74856 +2209 4 49.927 17.6315 27.8951 41.9068 -8.6615 -2.42711 +2210 4 51.4551 17.8493 28.3603 -3.47276 2.02156 5.1771 +2211 6 46.2645 37.0852 13.9854 4.42941 -15.3994 -45.1385 +2212 4 46.1048 37.4162 14.8449 -7.65894 23.339 32.9902 +2213 4 45.682 37.569 13.3645 -0.578519 -6.08013 10.2779 +2214 6 38.1859 37.2676 33.1408 3.52211 -11.0724 24.5555 +2215 4 38.5393 37.4103 34.0404 -6.68303 -10.0954 -6.88307 +2216 4 38.6219 37.9461 32.6369 2.42637 17.4604 -15.0111 +2217 6 41.8357 13.3473 31.1178 -16.0625 23.8584 17.742 +2218 4 41.5851 13.9423 31.8754 7.82637 -22.3228 -20.2899 +2219 4 42.4009 12.6411 31.4368 6.59024 -10.1979 3.85371 +2220 6 46.9027 12.6459 17.8387 -27.1897 30.7666 -32.0186 +2221 4 46.619 13.5972 17.8049 11.7948 -22.8605 3.48595 +2222 4 46.5208 12.2901 16.9886 18.0608 -3.03081 22.7278 +2223 6 32.0582 10.0955 10.6527 -31.4378 50.3229 23.4622 +2224 4 31.7762 9.76632 11.5317 8.81554 -8.40176 -19.9459 +2225 4 31.6698 11.0464 10.7004 29.7372 -48.0302 -12.3835 +2226 6 34.0062 11.3773 6.75186 17.7871 30.589 25.6979 +2227 4 33.4869 10.5999 6.69262 -19.6684 -30.9606 -3.70709 +2228 4 33.8274 11.7035 7.66069 0.227829 -0.558148 -16.2574 +2229 6 45.3288 30.8634 19.4834 2.25993 -0.395596 -7.26595 +2230 4 45.2654 30.706 20.4282 2.85912 -9.1252 8.63447 +2231 4 45.808 30.1003 19.1195 -1.86475 4.39364 7.74954 +2232 6 20.3535 0.575918 7.15275 2.53913 19.7072 2.1264 +2233 4 20.3036 0.62077 8.11765 -6.02971 -5.31178 -3.74759 +2234 4 20.3373 41.5708 6.90351 -3.42232 -20.4047 0.354773 +2235 6 15.9901 39.4523 4.14302 -22.6863 14.3541 -4.96379 +2236 4 15.4898 39.956 3.48033 13.9059 -6.08345 -3.0001 +2237 4 15.6535 39.8695 4.95456 5.06581 -11.7067 3.21286 +2238 6 52.4222 16.4823 25.1021 7.38571 -14.026 0.748627 +2239 4 51.9391 16.8928 25.8315 -3.23714 5.96419 -6.435 +2240 4 52.4547 17.0876 24.3371 -9.72126 -3.91711 12.1205 +2241 6 38.5305 12.9945 3.24722 36.6577 77.8042 9.91619 +2242 4 38.7269 13.7231 3.96388 -16.2716 -45.5952 -32.5571 +2243 4 38.0745 12.2732 3.61889 -23.0516 -27.5087 18.4748 +2244 6 35.1404 29.6968 31.1683 -32.7778 -10.63 75.6098 +2245 4 35.326 30.1595 30.3922 19.5999 28.8984 -42.5223 +2246 4 34.769 30.3505 31.8393 8.36493 -22.8372 -28.4638 +2247 6 9.52941 33.7628 4.86075 -28.4918 10.8311 18.4951 +2248 4 9.24769 34.3211 5.62607 6.24621 -9.23174 -22.6788 +2249 4 10.3628 33.3905 5.10095 17.2263 -8.07265 -0.549435 +2250 6 21.5384 22.0668 20.5377 -8.24916 -13.7408 18.0665 +2251 4 20.8389 22.6833 20.2982 1.69112 5.82217 1.92954 +2252 4 21.3229 21.7148 21.445 5.44386 11.4228 -26.5573 +2253 6 37.5752 11.1922 41.2961 -25.7405 -15.8592 15.4541 +2254 4 38.0284 11.8044 40.7564 10.4246 30.4728 -30.151 +2255 4 38.2644 10.586 41.5433 15.0535 -11.8566 15.4014 +2256 6 33.8981 1.42806 38.7459 -9.94409 -6.93964 -8.18458 +2257 4 33.592 0.608166 38.3248 2.39341 2.703 9.2739 +2258 4 33.9534 1.28552 39.7002 -3.4763 3.29487 -4.45631 +2259 6 4.57081 26.6822 28.0049 6.08842 -57.033 -35.5124 +2260 4 5.0914 25.8197 28.0746 -15.9746 40.4578 4.78317 +2261 4 4.85783 27.3427 28.6052 16.6445 16.915 24.1865 +2262 6 10.2586 0.903759 11.6235 -14.777 -30.5961 35.2813 +2263 4 10.598 1.12099 12.5147 -1.53351 -1.03605 -18.7158 +2264 4 10.5217 1.55247 11.0069 12.731 34.1315 -22.4253 +2265 6 17.6428 19.8087 2.34625 28.3489 11.7442 10.4095 +2266 4 17.8694 20.4455 1.65312 -0.920106 -2.92675 2.15413 +2267 4 18.5186 19.4679 2.66241 -18.7748 -2.39069 -7.57655 +2268 6 32.4269 25.6656 16.4745 -22.7384 46.4686 12.005 +2269 4 32.9526 26.0936 17.1754 -0.693509 -13.2017 -11.5041 +2270 4 32.8268 24.9018 16.1119 18.5502 -33.1172 -3.66835 +2271 6 33.2526 10.6326 0.323883 9.44704 -29.8166 -9.67306 +2272 4 32.8511 9.97264 41.5994 12.5609 21.6724 15.7642 +2273 4 34.1113 10.2426 0.662313 -26.6835 12.0422 -7.05376 +2274 6 4.94395 4.51414 10.1428 13.8645 5.4827 29.102 +2275 4 4.09398 4.95549 10.181 -4.94694 -3.34603 -2.54834 +2276 4 5.29018 4.56097 11.0773 -8.61071 -3.77852 -28.7481 +2277 6 27.0981 16.9726 9.55361 -31.982 10.5528 -14.2027 +2278 4 27.1645 17.5497 10.32 4.78099 0.707575 6.97209 +2279 4 26.2221 17.2303 9.15822 25.9284 -7.90001 11.4222 +2280 6 9.97547 10.5192 19.3751 2.18725 8.20489 55.882 +2281 4 10.4385 9.92127 18.8097 14.3325 -20.7925 -15.5795 +2282 4 10.1136 10.195 20.3283 -2.00877 10.2565 -41.5362 +2283 6 19.5726 8.5313 27.8509 32.1681 -5.32712 19.6321 +2284 4 20.0623 8.73326 28.6965 -13.9453 -3.32017 -28.6613 +2285 4 20.1531 7.88958 27.3718 -16.7413 15.1406 10.2365 +2286 6 47.0715 38.9553 23.1297 -19.9487 1.16408 5.20576 +2287 4 47.6755 38.9992 22.3956 6.55525 -5.77104 -8.99339 +2288 4 46.1921 38.7934 22.7438 5.29072 4.97192 1.21114 +2289 6 19.6864 25.3648 11.2698 -35.9279 -4.62509 3.50742 +2290 4 18.9891 24.6498 11.3772 26.0807 25.4649 -7.71219 +2291 4 19.2193 26.1995 11.535 7.74761 -20.7647 -6.77192 +2292 6 27.3916 13.4622 15.7395 34.9583 -25.2468 -27.4167 +2293 4 26.6227 13.8144 16.1317 -23.8298 14.7279 29.1585 +2294 4 28.0863 13.1847 16.3728 -7.05347 8.15442 -0.924368 +2295 6 18.6718 14.1326 1.43279 -0.407031 -28.5308 -28.57 +2296 4 18.3771 15.0354 1.29678 -0.169849 11.7565 -8.38297 +2297 4 19.1904 13.8513 0.615983 -22.2167 19.1803 27.2908 +2298 6 42.3082 22.0346 32.4819 -45.1257 5.10199 -13.868 +2299 4 42.1064 21.5657 33.301 1.02444 -1.81924 7.74271 +2300 4 41.4227 22.4584 32.2639 35.231 -14.359 4.36271 +2301 6 10.0299 9.44853 2.50633 35.8335 -20.1603 -5.5533 +2302 4 9.22808 9.80314 2.87263 -22.9312 8.40439 12.9687 +2303 4 10.3707 8.71125 3.07205 -18.436 14.324 -8.13067 +2304 6 6.82989 1.45163 22.0085 -48.1074 -31.7833 -34.6048 +2305 4 5.93364 1.52189 21.5813 27.761 13.2569 19.2226 +2306 4 6.99793 0.508973 21.801 12.0554 14.7409 9.93393 +2307 6 11.2802 27.0298 18.9733 1.62982 48.8223 -5.8971 +2308 4 11.8533 27.1031 19.7597 -5.53045 -6.49976 -4.21856 +2309 4 11.2066 27.9871 18.6476 2.337 -33.8373 14.078 +2310 6 41.4807 20.5084 27.2133 -10.1157 30.3313 5.28758 +2311 4 41.6238 21.1535 27.9303 0.1153 -0.646751 -15.7402 +2312 4 41.3475 19.7242 27.7174 2.20222 -28.2193 4.24429 +2313 6 15.4457 24.115 33.4309 -8.0908 -15.9975 4.96928 +2314 4 14.6694 24.1264 34.0087 5.2648 16.329 -3.20307 +2315 4 15.6051 23.1634 33.3621 10.6851 2.75783 3.25666 +2316 6 36.1374 16.3773 10.0083 -2.95201 1.72364 21.0093 +2317 4 36.0354 15.4723 9.6971 0.275369 -1.57281 -6.84486 +2318 4 36.1532 16.3058 10.9756 2.3103 1.89663 -9.38056 +2319 6 51.7249 16.2592 2.09899 -0.8354 -35.479 4.00209 +2320 4 51.3025 16.6477 2.84061 -15.4293 29.383 24.1936 +2321 4 51.7588 15.3279 2.40044 5.70816 13.7616 -13.313 +2322 6 23.409 8.55726 39.7719 39.5062 -11.15 -25.6965 +2323 4 23.7264 8.82822 38.8637 -18.295 -2.70527 32.3134 +2324 4 24.154 8.00621 40.1033 -17.8621 14.2471 -2.43096 +2325 6 36.7611 34.4487 21.1056 -9.59584 -7.71653 -9.58874 +2326 4 37.1943 34.5847 20.2534 -2.45984 1.11901 0.357954 +2327 4 35.8017 34.351 20.9183 13.0848 5.20904 4.89404 +2328 6 14.146 8.88688 27.2949 11.3522 43.6232 -16.453 +2329 4 13.5534 8.17113 27.3093 -27.716 -37.4722 8.68734 +2330 4 15.0033 8.5993 27.5988 11.0136 -4.6565 4.44913 +2331 6 20.6652 37.4903 25.1946 -10.211 -17.9881 -36.0994 +2332 4 20.7454 36.6557 24.6643 4.11278 14.2078 23.4923 +2333 4 20.5382 38.1243 24.4693 3.50396 4.35638 18.4557 +2334 6 28.825 24.4792 30.0383 -7.87557 -12.5525 -14.3175 +2335 4 28.2203 24.3409 29.2957 -5.62902 14.2643 8.72595 +2336 4 29.6177 24.0933 29.6588 14.1928 -3.34691 9.72359 +2337 6 8.38024 12.0023 23.6849 17.6034 -17.8042 43.8798 +2338 4 9.33151 12.0391 24.0095 -25.5352 0.9508 -22.7134 +2339 4 7.93543 11.4413 24.3789 8.15752 13.9726 -18.9857 +2340 6 16.0957 26.6613 22.9482 -4.23776 -4.88874 3.00129 +2341 4 16.4041 25.8866 22.4682 2.11349 3.20317 -0.347462 +2342 4 15.2797 26.4088 23.4009 6.04671 4.79823 1.078 +2343 6 22.346 41.3881 9.48723 24.9275 -16.664 -2.62618 +2344 4 22.5706 0.299269 9.06271 5.87112 18.1013 -4.15908 +2345 4 21.5005 41.5154 9.87839 -30.5435 3.49176 4.55444 +2346 6 49.3776 19.1851 32.3736 41.1751 -38.6142 12.6649 +2347 4 49.9515 18.5305 32.8666 -19.8114 22.1793 -24.5398 +2348 4 48.9751 19.6643 33.0815 -18.7203 16.5505 12.5326 +2349 6 29.672 28.434 31.2292 -0.0990093 -59.7528 33.1636 +2350 4 30.5672 28.114 31.0525 8.33151 24.242 -15.2883 +2351 4 29.4026 27.6233 31.7702 -3.76231 36.9508 -17.5145 +2352 6 5.09757 39.1181 23.5694 28.9365 -16.8561 66.257 +2353 4 5.426 38.785 24.4883 -20.96 9.44698 -53.4069 +2354 4 5.17377 40.064 23.6953 -4.19226 13.7611 -6.16678 +2355 6 42.9396 13.594 41.6013 33.1291 -45.1938 12.1175 +2356 4 42.8466 14.3322 41.0449 -16.6361 37.6348 -21.2948 +2357 4 42.1546 13.3797 0.17078 -22.3633 5.8076 7.08965 +2358 6 21.2201 12.4318 7.37385 41.5974 -14.6934 -10.3279 +2359 4 20.2896 12.3563 7.35505 -36.2241 5.92132 -7.85999 +2360 4 21.5284 11.6004 6.96932 1.7608 11.2928 4.8084 +2361 6 43.1404 26.8989 37.6922 38.0431 -66.5876 34.8581 +2362 4 42.455 26.3454 37.3085 -15.3628 11.0452 -11.3741 +2363 4 43.7284 26.1839 38.1775 -25.099 52.0029 -25.4853 +2364 6 19.5406 10.6485 41.687 -7.00401 -34.9019 -10.1363 +2365 4 19.0738 10.6767 0.596923 -7.19888 -1.38148 21.2635 +2366 4 19.8536 11.5162 41.559 12.2515 43.5875 -9.13673 +2367 6 53.6223 10.061 3.2559 12.5469 7.56169 -12.6981 +2368 4 54.2024 10.8465 3.22155 -5.5124 -7.95383 7.8004 +2369 4 54.0687 9.40413 2.68363 -10.8512 12.6529 5.34221 +2370 6 17.5742 20.1926 28.4231 -27.2496 23.4973 23.4861 +2371 4 18.0413 19.6307 27.8376 17.787 -14.8025 -21.0857 +2372 4 18.1273 20.2938 29.2048 3.54631 -0.489564 0.0042962 +2373 6 36.884 7.32584 1.68504 -56.6071 21.2656 -14.3658 +2374 4 37.7051 7.59774 2.01592 38.2946 9.18211 20.2394 +2375 4 36.4748 8.1931 1.44071 3.42518 -20.8507 2.42249 +2376 6 29.2181 41.4159 1.83346 -7.01124 13.363 14.2223 +2377 4 28.4272 0.01466 2.15652 15.3791 -9.50345 -13.4545 +2378 4 29.1899 41.2946 0.880744 -4.61983 7.49126 -6.31737 +2379 6 13.5157 3.09172 8.12958 -12.3356 7.91728 -16.4605 +2380 4 12.824 3.78046 8.01164 12.4629 -9.10221 7.3254 +2381 4 13.8551 3.1491 9.02604 -1.1531 -1.24526 3.73064 +2382 6 15.0243 29.578 18.5071 -0.689822 5.1468 -1.91807 +2383 4 14.6889 28.924 17.8685 -1.8514 4.35612 11.642 +2384 4 14.2858 30.1508 18.7969 8.46412 -5.78667 -10.3485 +2385 6 10.5031 24.7013 24.3729 39.9308 52.3958 -21.489 +2386 4 10.8696 24.6855 23.439 -22.6214 -1.85919 30.3756 +2387 4 10.1444 23.8694 24.566 -23.1097 -44.7323 0.689524 +2388 6 2.33043 13.8499 25.1512 12.2217 -8.49201 10.1592 +2389 4 1.51988 13.5482 24.7402 -5.80441 -9.83551 -11.7005 +2390 4 2.2572 14.7938 25.1495 -10.3249 16.8303 -2.61333 +2391 6 31.8608 32.7615 29.8175 -5.917 1.92483 -13.0568 +2392 4 30.9148 32.9142 29.9093 1.86919 3.45723 4.06263 +2393 4 31.9038 31.8703 29.4643 1.33296 -6.10517 -4.90202 +2394 6 37.5413 40.8309 33.9785 -53.8639 -49.1526 -10.38 +2395 4 37.2515 40.0243 34.5353 23.0474 40.5808 -8.35317 +2396 4 36.818 40.8104 33.2846 24.4839 11.2763 19.2644 +2397 6 24.0486 38.1463 34.3459 4.38709 -25.8386 -29.9356 +2398 4 24.1932 38.0251 35.2675 1.20986 12.6476 31.9448 +2399 4 24.4562 37.3431 33.9843 -4.45208 9.66559 -5.62065 +2400 6 37.1813 22.5726 7.37313 12.7367 -26.0408 21.8779 +2401 4 37.6868 21.7363 7.50199 -14.9443 17.386 1.08188 +2402 4 37.2974 22.7741 6.46124 2.1827 3.60906 -24.8808 +2403 6 4.31908 23.2435 35.594 -25.7168 -2.52913 6.61784 +2404 4 4.31865 22.3787 35.1609 -1.33991 4.89576 -0.266123 +2405 4 3.37757 23.4898 35.7698 13.7393 -2.9658 -3.46645 +2406 6 15.7444 14.893 2.66063 14.3192 36.2435 46.5189 +2407 4 15.9445 15.8567 2.71494 4.00237 -25.0016 7.78932 +2408 4 15.3014 14.8369 1.84861 -12.1852 -13.1154 -36.1328 +2409 6 48.1607 23.1823 2.03014 17.998 -4.54201 -11.9107 +2410 4 48.5744 23.458 2.84259 8.43731 2.94545 12.5813 +2411 4 48.9225 22.9045 1.46682 -22.9697 5.41467 1.46601 +2412 6 24.1212 19.9771 21.5555 -13.5297 -6.85262 15.9953 +2413 4 24.2241 19.3198 22.2577 -12.7792 13.8262 1.69378 +2414 4 24.7627 19.6352 20.9706 23.452 2.79195 -33.2435 +2415 6 10.5793 29.3754 5.15175 -1.75103 26.9922 -14.4666 +2416 4 9.93004 29.8841 4.64694 -13.9608 -12.0643 5.47156 +2417 4 11.3599 29.8389 4.86113 16.4531 -5.21099 6.28998 +2418 6 5.96767 27.6933 31.2336 10.2296 -18.0279 -26.5205 +2419 4 6.63185 27.1353 30.7398 -17.0624 11.0978 13.8341 +2420 4 6.49058 28.2721 31.7915 6.44996 0.578865 12.7715 +2421 6 18.5397 25.8071 15.3312 30.8629 -17.2743 -78.9847 +2422 4 18.3277 25.7099 16.2038 -28.7942 6.39581 79.7195 +2423 4 17.897 26.3418 14.8644 -17.4943 11.9017 11.8989 +2424 6 52.0949 37.2335 11.1138 -0.736115 -25.1617 0.200807 +2425 4 52.5552 36.4743 10.7101 2.49656 11.0988 9.7325 +2426 4 52.7586 37.8745 11.3958 -2.29245 7.10647 -7.85035 +2427 6 46.8562 14.6296 7.3094 -39.0502 -6.9365 63.794 +2428 4 46.1382 15.0906 7.8718 34.2719 -4.68193 -40.7336 +2429 4 47.0431 13.9061 7.9424 14.2062 7.46383 -20.3992 +2430 6 22.2508 0.698906 41.6783 16.129 -5.34947 -25.8041 +2431 4 22.2008 1.66415 41.7125 4.72421 -6.65403 -6.59212 +2432 4 22.9559 0.389699 41.0229 -20.0941 20.4891 31.5318 +2433 6 4.05761 14.7345 9.27152 -10.7438 13.6286 -6.0443 +2434 4 3.56043 15.5915 9.15395 12.8436 -23.8424 -1.56379 +2435 4 4.93811 14.8828 8.92118 3.87558 5.66633 -1.10852 +2436 6 37.2917 12.6666 37.0157 -30.741 -16.0859 47.3668 +2437 4 37.7371 12.676 37.8973 0.89189 9.6387 -16.8975 +2438 4 36.3707 12.3712 37.2872 32.4569 8.65188 -22.8431 +2439 6 26.6682 29.0903 40.5985 -18.9168 16.4285 3.4146 +2440 4 27.032 28.2632 40.812 19.8197 -36.7417 16.2821 +2441 4 26.6469 29.0593 39.6552 2.37875 14.8387 -20.8034 +2442 6 7.22455 13.851 3.31845 32.6668 -55.3021 -17.7697 +2443 4 8.0198 14.2759 3.60088 8.05656 35.1068 9.02454 +2444 4 7.66854 12.9807 3.04146 -45.3946 28.1811 11.8363 +2445 6 8.95271 34.8627 28.8342 33.802 -52.1542 -15.9648 +2446 4 9.89817 35.0055 28.6074 -18.5208 0.484683 7.95646 +2447 4 8.56267 35.6958 28.9173 -17.8026 46.8286 13.0667 +2448 6 37.1756 40.0691 40.1061 46.0034 7.56439 6.60252 +2449 4 36.245 40.1688 40.0074 -20.2243 -4.13511 -1.70673 +2450 4 37.2907 39.5142 40.8911 -6.64471 -1.97244 -3.69085 +2451 6 30.3689 6.165 27.2364 16.9392 12.8422 63.3115 +2452 4 30.1126 5.75506 28.1249 0.00544273 9.78172 -37.0876 +2453 4 31.0397 6.83064 27.5702 -18.6179 -11.6186 -23.6342 +2454 6 10.4791 22.885 18.2972 2.22892 -25.7937 -34.5052 +2455 4 11.3494 23.0331 18.653 10.7715 4.73748 7.10061 +2456 4 10.6446 22.3032 17.5049 -10.188 21.0769 23.5682 +2457 6 35.8886 14.2524 40.1239 38.6938 29.9036 -1.43051 +2458 4 35.4161 14.6576 39.3846 -1.71718 -13.5804 13.4977 +2459 4 35.4021 13.6019 40.5864 -31.0402 -18.1501 6.5583 +2460 6 6.71723 1.08854 17.7001 -3.83901 -60.8198 25.71 +2461 4 6.23156 1.19942 18.5167 -3.21909 18.7445 0.671973 +2462 4 6.88149 0.099135 17.7878 0.895752 34.2898 -15.7018 +2463 6 41.3468 34.0461 33.1794 10.5682 19.0983 -18.7578 +2464 4 40.4721 34.2712 32.8864 -29.2649 -1.70533 3.43004 +2465 4 41.8357 34.5632 32.5195 11.425 -3.18121 9.05585 +2466 6 37.2595 0.990816 41.287 9.45411 17.3584 -9.40071 +2467 4 37.687 0.20533 40.9743 -1.4253 -22.058 -8.3634 +2468 4 37.4586 1.01742 0.30817 4.28067 1.92511 18.4856 +2469 6 25.2602 30.9527 6.20609 -41.9214 10.7977 -12.9978 +2470 4 25.877 31.4326 5.6764 28.9604 0.775163 -4.96937 +2471 4 24.4759 30.9469 5.60333 12.4846 -9.23957 25.2824 +2472 6 14.2056 24.502 28.3086 -25.5247 14.5131 -24.5719 +2473 4 14.1882 23.6623 28.7056 13.4522 -31.4953 30.087 +2474 4 13.7133 24.2842 27.5041 7.94148 19.2098 -3.82225 +2475 6 34.2051 26.2238 36.0112 -48.9031 41.3361 24.9979 +2476 4 35.1144 26.3624 36.1822 32.7561 -2.50775 4.45543 +2477 4 33.7446 26.9807 36.5344 19.2218 -36.9328 -23.3608 +2478 6 32.3568 8.33098 28 25.7802 40.2385 3.20277 +2479 4 32.7565 9.24505 28.063 -37.9579 -17.4528 3.85033 +2480 4 33.1461 7.94224 27.6538 8.5967 -27.8742 -9.28785 +2481 6 11.7867 0.286536 26.9724 -1.3913 -35.2382 4.72224 +2482 4 11.7865 41.2385 26.6946 0.846362 23.7064 4.93964 +2483 4 11.6054 0.272418 27.9282 2.03777 4.09428 -12.4872 +2484 6 1.68124 0.254113 10.3309 8.7986 -13.2184 -15.0921 +2485 4 1.59717 41.2916 10.7333 -0.0350141 -2.89412 -0.990995 +2486 4 1.41389 0.849687 11.0071 -7.7361 15.4014 20.6266 +2487 6 6.75173 13.8377 8.23874 -3.6693 30.6435 -30.4665 +2488 4 6.43924 13.9799 7.29904 9.51956 -14.6006 30.1073 +2489 4 7.1653 14.6974 8.43116 5.95594 -9.45057 4.81521 +2490 6 22.2348 20.5564 6.16471 -24.0844 -9.72934 13.195 +2491 4 21.6727 21.3518 6.25881 9.87637 -7.56006 0.262552 +2492 4 21.7029 19.8181 6.55593 11.5262 14.9976 -6.6436 +2493 6 17.385 20.4497 10.8769 -35.9329 27.9153 -37.8305 +2494 4 16.5515 20.156 10.4074 25.3596 -4.97581 21.0147 +2495 4 17.441 21.3848 10.5386 11.6957 -25.2138 21.3318 +2496 6 17.7006 4.52737 19.573 -11.3777 -34.9061 -6.08889 +2497 4 17.032 4.43128 20.2569 -5.49224 11.1956 3.68583 +2498 4 17.4813 3.72403 19.0236 15.4315 33.5846 4.92098 +2499 6 0.483339 18.1114 40.0861 11.4726 -7.5634 -25.4826 +2500 4 0.218803 18.6551 40.8031 -6.40406 19.3 17.6992 +2501 4 1.29471 18.4968 39.6981 -7.50073 -9.94226 4.45973 +2502 6 22.9439 24.8131 27.8304 -1.07592 37.7895 -56.3844 +2503 4 22.8309 25.5845 27.1671 -0.125595 -37.7338 24.1587 +2504 4 22.7938 25.2149 28.6606 -3.1997 14.6603 34.334 +2505 6 42.7926 39.1547 26.7662 4.75434 20.2168 6.00074 +2506 4 43.0175 38.5002 26.1242 -2.01943 -24.6309 -11.9253 +2507 4 43.3024 39.9142 26.4608 -1.73796 0.515913 11.2644 +2508 6 26.2338 3.05974 21.8008 -0.713756 21.3652 -6.58596 +2509 4 25.6341 3.75271 22.1513 17.432 -13.3686 -8.49125 +2510 4 26.841 3.50549 21.1637 -15.4189 -7.95734 10.2455 +2511 6 54.5913 9.88629 29.5891 14.6194 -0.200122 15.6168 +2512 4 54.0185 9.11016 29.6389 -2.18077 1.53735 0.0476299 +2513 4 54.8498 10.0557 30.5251 -12.748 -2.88746 -21.9109 +2514 6 24.7662 33.7505 20.5324 -4.4887 -11.5901 7.32024 +2515 4 24.6764 34.6709 20.8407 -1.82029 -5.26135 -2.53883 +2516 4 23.9322 33.4503 20.1388 -0.463927 12.2923 -3.35723 +2517 6 41.7034 16.3049 0.90063 -4.83399 22.4927 -47.1255 +2518 4 41.2734 15.9533 1.64089 -16.394 -13.425 40.883 +2519 4 42.6233 16.3659 1.12415 18.2298 -9.67465 4.77205 +2520 6 23.3998 27.9207 27.4832 -10.7606 37.0497 -28.3533 +2521 4 22.8282 28.3407 28.1441 5.00816 -9.79407 0.156118 +2522 4 23.2556 28.495 26.6632 8.58882 -24.5485 28.392 +2523 6 32.7859 37.2984 18.7364 25.7014 -40.2058 6.96479 +2524 4 33.7401 36.9719 18.7703 -32.5146 22.7172 4.70252 +2525 4 32.7784 38.1932 18.4283 6.4981 19.1078 -10.0488 +2526 6 21.2249 27.6889 4.78917 1.7584 -25.2435 -20.8654 +2527 4 20.596 27.4146 5.46499 -5.42949 1.48454 -4.75098 +2528 4 21.0369 27.1287 3.96943 -0.427807 22.4392 26.4825 +2529 6 54.9457 17.9605 1.83049 24.1732 12.1415 15.992 +2530 4 54.6765 17.1472 1.44643 -11.2843 -21.2768 -12.0273 +2531 4 54.1938 18.5428 1.86671 -18.1074 1.0363 -7.50679 +2532 6 36.7435 10.702 6.59289 -49.1612 2.30359 2.88264 +2533 4 35.7736 10.9925 6.66913 36.3355 -9.83622 -8.29906 +2534 4 36.7226 9.77144 6.87602 6.19961 4.27664 0.325158 +2535 6 54.2959 4.49421 14.021 -47.0247 26.1641 -8.2037 +2536 4 53.712 4.99768 13.3924 28.2438 -8.88077 8.93165 +2537 4 53.834 4.66365 14.8572 10.6634 -9.95324 4.36694 +2538 6 22.1071 12.8195 32.0067 31.7906 8.9597 -11.0311 +2539 4 21.2967 13.3066 31.9589 -27.922 0.108445 -0.906739 +2540 4 22.6887 13.2954 31.3728 -6.4895 -15.5456 16.1837 +2541 6 15.3021 36.6565 4.03444 -21.8215 23.8176 13.2077 +2542 4 15.3262 37.6185 3.88215 -1.10116 -7.72226 9.53853 +2543 4 16.0423 36.3695 3.52653 17.7184 -15.2462 -10.6327 +2544 6 23.951 1.27123 5.71091 12.3119 19.4094 13.4558 +2545 4 23.1735 0.716989 5.76524 -11.3354 -5.61231 -0.786433 +2546 4 24.0519 1.77027 6.55293 -6.00641 -12.6326 -15.7345 +2547 6 14.2792 12.648 15.8066 19.0644 9.13243 11.8341 +2548 4 14.5911 12.5731 14.893 -12.6174 -10.6299 -3.28453 +2549 4 13.3818 12.3002 15.9605 12.2346 2.97194 -15.7557 +2550 6 15.0388 40.2481 6.5891 -30.9219 -16.0267 -20.9978 +2551 4 15.8926 40.3583 6.97574 17.8619 16.6743 19.574 +2552 4 14.4622 41.0349 6.73493 18.0926 -11.8876 3.06612 +2553 6 48.5605 32.6308 12.0872 21.4935 -15.1737 -19.6402 +2554 4 48.2882 31.8163 11.6222 -11.7375 10.5522 8.8403 +2555 4 49.3772 32.8772 11.5869 -20.063 0.749688 13.0696 +2556 6 11.2909 31.5377 7.21713 -14.6129 -9.26005 -15.8818 +2557 4 10.6224 30.9548 6.78826 17.7824 9.96971 10.6082 +2558 4 11.6163 32.1134 6.50388 0.884245 -9.77636 6.63484 +2559 6 30.1231 27.9968 10.2226 9.10006 8.28679 -14.6513 +2560 4 30.718 28.7273 9.95045 -8.34799 -9.59518 10.9295 +2561 4 29.9727 27.4897 9.40845 -5.6962 -0.318113 1.27302 +2562 6 27.6759 22.1164 17.3809 2.93811 -8.1883 -22.8269 +2563 4 27.2909 21.5233 16.7142 1.55949 -2.9899 10.1125 +2564 4 28.0309 22.8242 16.8263 2.77593 4.45495 11.6125 +2565 6 12.9654 4.59514 18.1625 -0.934721 -11.3223 -0.518608 +2566 4 13.4589 3.798 18.4727 -12.2499 12.1104 -13.3514 +2567 4 12.4628 4.36939 17.3497 12.7979 1.84773 4.27522 +2568 6 19.7203 6.71654 19.0744 25.855 21.5282 16.2244 +2569 4 18.977 6.16103 19.2554 -18.9537 -21.446 -0.739234 +2570 4 20.1996 6.78409 19.9214 -9.72031 -0.922856 -11.6068 +2571 6 37.1527 31.3787 11.4669 20.5156 -3.08539 55.9419 +2572 4 36.5467 31.6235 12.1801 -19.4555 -0.126446 -17.2692 +2573 4 37.8531 31.0173 12.0578 -6.7166 -8.42047 -30.0342 +2574 6 3.11862 16.2015 27.3491 -14.8948 -19.7352 -9.46107 +2575 4 2.52427 15.4561 27.6487 20.3886 21.5408 -12.2486 +2576 4 3.15348 16.212 26.3649 -6.24389 -0.0501167 23.7097 +2577 6 15.7133 9.97724 38.3591 30.328 17.4212 13.8857 +2578 4 16.1258 10.8398 38.0549 -11.3336 -30.4403 16.2583 +2579 4 16.257 9.66317 39.1359 -16.0932 10.0631 -23.9552 +2580 6 13.4043 14.2884 8.2363 15.0986 25.1191 -5.83206 +2581 4 13.804 15.2225 8.33958 -5.13839 -47.7054 6.28407 +2582 4 14.0947 13.5837 8.31616 -11.6402 16.8216 1.41307 +2583 6 1.71524 24.3141 36.392 36.4901 -22.2748 31.9402 +2584 4 1.86474 25.1068 36.8985 9.35176 9.25273 5.49175 +2585 4 1.1215 24.6177 35.7571 -36.8309 10.6894 -41.0698 +2586 6 11.1862 26.5319 32.9688 15.239 -24.9993 36.2438 +2587 4 10.9649 26.8002 32.096 -11.5382 16.0703 -24.8314 +2588 4 11.1647 27.266 33.6054 -7.17864 1.89937 -11.754 +2589 6 29.5773 0.765668 36.2911 32.6527 8.9619 33.1448 +2590 4 29.1495 0.596705 35.4758 -23.483 -6.97315 -25.4485 +2591 4 28.9625 1.07408 36.9696 -5.35236 0.153158 -12.2969 +2592 6 43.6099 13.1071 23.908 -7.75428 16.7256 -33.2383 +2593 4 42.8302 13.3868 24.3919 -4.08537 -1.1131 9.93358 +2594 4 43.3622 13.2586 22.9511 7.4693 -9.27191 32.0602 +2595 6 7.44309 19.7767 19.6705 17.8438 12.6527 -6.23579 +2596 4 6.73015 19.1919 19.919 -3.61392 -10.9972 -0.189724 +2597 4 7.6227 19.7194 18.722 -11.1837 -0.704544 3.42764 +2598 6 24.4259 4.29913 7.83629 -8.5248 -0.10499 -3.36953 +2599 4 24.144 5.21077 7.98541 -0.150025 -7.47068 -3.31634 +2600 4 24.9904 4.0546 8.57206 4.90899 -0.271036 -1.18338 +2601 6 51.4883 30.2308 31.1674 -14.7545 1.56633 -0.747328 +2602 4 50.5925 29.8847 31.2768 -1.35209 3.55691 8.49804 +2603 4 51.5844 30.2463 30.2146 11.2248 2.3182 -11.9335 +2604 6 0.913373 23.6795 16.8764 44.9279 -35.4578 23.1065 +2605 4 0.053834 23.3329 16.7065 -24.7033 4.18361 -15.1926 +2606 4 1.39802 22.8443 17.1197 -4.68332 28.5423 -3.90241 +2607 6 45.0884 19.3939 15.6913 9.05154 29.148 -44.7311 +2608 4 45.9115 18.9543 15.4906 10.1171 -6.0821 0.331933 +2609 4 44.8041 18.9926 16.4702 -27.3917 -26.115 43.7395 +2610 6 17.5003 8.70625 40.5861 -20.5343 49.5779 -9.15489 +2611 4 18.1762 9.35755 40.8219 0.532033 0.318295 -4.52849 +2612 4 17.8864 7.89597 40.8225 20.4785 -39.0634 11.6529 +2613 6 30.1832 27.259 27.1983 -17.9859 30.5387 -1.70378 +2614 4 31.0843 27.5469 27.0174 5.19664 -5.65516 3.8328 +2615 4 29.6652 28.1124 27.2385 17.8651 -30.9588 0.0373123 +2616 6 43.0672 26.1987 28.3737 -1.21405 11.7795 -35.2128 +2617 4 43.2187 25.7399 27.5308 2.18298 5.51683 1.33219 +2618 4 43.1307 25.5038 29.0079 -1.74848 -11.3154 21.2466 +2619 6 27.987 7.5851 3.0601 9.13665 18.2748 23.7588 +2620 4 28.1896 6.93215 2.40721 -2.30749 -24.2619 -13.6918 +2621 4 28.5512 7.39371 3.84357 -9.52219 0.418204 -9.11945 +2622 6 44.6779 7.22362 10.1855 -3.82519 12.3682 29.7072 +2623 4 44.5846 7.37997 11.1613 -8.64186 4.71212 -23.3906 +2624 4 45.2067 6.43644 10.1815 9.68596 -14.557 -3.94398 +2625 6 23.537 20.3907 32.2607 -4.33975 0.880185 -5.57314 +2626 4 23.324 21.1985 32.7413 -3.519 5.94106 -1.71472 +2627 4 23.9311 19.8373 32.9365 5.99895 -7.24541 1.02787 +2628 6 37.5412 21.0533 29.2807 6.26587 16.0676 16.0196 +2629 4 37.3761 20.3248 28.6837 -16.0493 -11.7352 -10.5522 +2630 4 36.7218 21.4261 29.6708 7.43039 -8.09007 -9.52559 +2631 6 49.2859 29.0787 28.7031 8.16517 -18.5587 -1.11584 +2632 4 48.658 29.8007 28.598 1.09858 8.52384 -10.5349 +2633 4 50.1522 29.3365 28.3345 -7.12297 8.09394 6.40204 +2634 6 47.5144 18.1684 15.2382 -13.098 45.3115 -50.4885 +2635 4 48.063 17.6794 15.7982 26.613 -22.2712 34.0874 +2636 4 48.011 18.9832 14.9644 -13.0138 -21.3801 10.9042 +2637 6 23.2587 11.168 16.5961 -34.2623 -16.0228 11.9175 +2638 4 23.8181 11.8474 16.2701 22.3391 18.1069 -12.9732 +2639 4 23.6107 10.3074 16.3447 5.63526 2.71733 -4.05723 +2640 6 3.14661 8.32736 23.1966 -5.33081 14.6732 5.33529 +2641 4 3.33443 7.84562 22.3891 5.23826 -4.81966 -4.36628 +2642 4 3.62138 9.17513 23.1245 -2.82501 -4.35917 1.75332 +2643 6 0.508878 16.1819 6.17622 16.4304 7.97407 55.7173 +2644 4 1.47866 16.3831 6.12713 -25.5039 -9.61354 -6.44341 +2645 4 0.329178 16.1408 7.1857 2.48639 -0.0834422 -46.7437 +2646 6 43.1796 15.6993 5.84098 -15.9449 -20.1226 -10.4934 +2647 4 42.9586 16.4507 6.36104 0.864404 19.5468 17.3894 +2648 4 44.0486 15.8407 5.47017 17.9332 8.6581 -2.45416 +2649 6 16.7038 35.4743 34.4518 -23.198 12.4372 32.502 +2650 4 15.9504 35.0582 34.0028 7.47206 -3.63127 2.95791 +2651 4 16.3197 35.7905 35.3305 20.1374 -9.24319 -26.2799 +2652 6 38.8854 7.73874 15.6833 27.6202 35.8952 13.402 +2653 4 39.2486 7.07212 15.1014 0.737034 -8.76325 -8.48971 +2654 4 39.6641 8.33099 15.9666 -32.1226 -27.7665 -11.1551 +2655 6 42.0076 36.5182 13.641 -8.45099 16.164 -4.64077 +2656 4 41.9228 35.5752 13.5656 2.538 -16.9665 4.44933 +2657 4 41.1544 36.8356 13.3036 3.7559 4.14555 2.82714 +2658 6 54.2986 15.3848 32.1119 10.5246 -16.1102 10.831 +2659 4 0.035655 15.9755 32.3754 -8.42237 -3.15332 1.00609 +2660 4 53.5781 15.9253 31.7943 -3.3302 7.96061 -4.64421 +2661 6 22.8954 13.9973 39.0304 35.7671 -1.21675 7.49641 +2662 4 23.2761 14.8055 39.421 -4.93619 -7.73369 -6.00904 +2663 4 21.9819 14.1606 38.8837 -32.0989 6.28079 -4.51925 +2664 6 48.0426 28.53 4.78367 -18.7604 -12.0579 33.007 +2665 4 48.5209 28.7824 4.01456 21.1512 11.8238 -22.7946 +2666 4 47.6247 29.3288 5.14776 5.26678 3.3179 -1.38234 +2667 6 48.833 10.6059 2.66638 -9.19187 -9.9608 -41.9733 +2668 4 48.2371 10.184 3.25557 -19.2293 -15.3999 15.8868 +2669 4 49.4018 11.1117 3.19515 27.1663 25.8201 26.2609 +2670 6 17.1043 29.3494 4.41938 0.116954 -3.05469 4.91749 +2671 4 16.3442 28.823 4.73493 -1.75912 12.177 1.49975 +2672 4 17.4207 29.929 5.14153 -0.429925 -17.6765 -0.899977 +2673 6 27.7901 7.33424 26.577 58.6208 -10.7281 -9.65958 +2674 4 28.6921 6.89516 26.6033 -20.1634 35.8081 4.28732 +2675 4 27.2961 6.54785 26.6418 -36.3357 -24.7905 3.70209 +2676 6 18.0242 22.0537 22.5144 -27.9591 -16.1551 -40.0832 +2677 4 18.4878 21.2118 22.5153 10.7066 -2.42354 6.7168 +2678 4 17.4966 21.98 21.6478 21.0889 16.8172 36.9195 +2679 6 22.144 25.0979 16.6837 -22.767 31.6961 -6.75713 +2680 4 21.8754 25.6012 15.8609 3.46788 -12.1894 37.0641 +2681 4 22.4796 24.2953 16.3382 13.1119 -24.3628 -7.92486 +2682 6 25.5147 28.4379 7.13209 -32.2353 18.5879 42.0502 +2683 4 25.3191 28.6153 8.09624 16.8162 -18.2828 -29.7283 +2684 4 25.4949 29.3399 6.82105 5.5127 9.28731 -21.7507 +2685 6 42.5447 24.7469 23.7482 -26.0567 17.8354 -0.260974 +2686 4 41.659 25.0561 24.0862 27.8337 1.55541 -7.56443 +2687 4 42.5141 23.8045 23.8516 -5.7883 -22.6777 0.706816 +2688 6 6.24511 16.6188 2.47068 -21.6781 9.7655 5.77715 +2689 4 5.36273 16.9874 2.41541 -6.24724 13.8235 -1.18511 +2690 4 6.01398 15.7093 2.58331 16.9883 -26.009 1.35247 +2691 6 47.3719 33.28 1.46148 -3.99946 1.01934 -28.2481 +2692 4 46.9803 34.1218 1.66358 -4.59906 12.9067 -8.65937 +2693 4 47.69 33.0389 2.30921 14.6803 -12.3184 23.7614 +2694 6 1.27616 36.1851 24.8829 8.16993 1.58395 -5.27854 +2695 4 0.639753 36.4584 25.5359 -13.8461 11.829 3.50901 +2696 4 1.57271 35.3754 25.2942 10.46 -9.74103 -2.86729 +2697 6 20.9413 29.0442 16.4303 -37.0385 3.95749 11.2157 +2698 4 21.4069 28.5201 15.8013 19.747 -14.8546 -14.4583 +2699 4 21.4101 29.8248 16.6953 16.4704 9.62387 -0.234111 +2700 6 18.6701 32.5426 14.1399 -11.935 -28.2137 10.094 +2701 4 17.8036 32.9051 14.2078 -15.3524 29.2867 2.90472 +2702 4 18.4356 31.618 14.3552 23.1856 4.50503 -1.59621 +2703 6 15.7338 41.7002 0.007017 -29.1796 -38.8659 -6.04008 +2704 4 15.5134 41.1073 41.1476 16.5192 17.684 16.0218 +2705 4 15.1804 41.3134 0.738607 16.9589 18.7767 -12.0866 +2706 6 20.5358 18.4015 7.20723 -36.4209 10.7746 11.3165 +2707 4 20.1727 18.4996 8.12034 18.5895 1.11111 -8.73102 +2708 4 19.7156 18.4439 6.66948 20.5956 -6.66311 2.45516 +2709 6 35.3359 2.82506 1.61733 -4.03181 47.7257 29.2165 +2710 4 34.9541 3.20961 2.47337 19.1106 -23.159 -34.5889 +2711 4 35.8528 3.61912 1.28524 -9.69035 -30.1723 1.40188 +2712 6 49.0059 19.6751 24.9502 -26.306 10.305 -4.58994 +2713 4 49.8292 19.282 24.7191 18.9727 -16.8119 -2.00329 +2714 4 49.219 20.61 24.9195 -6.54834 1.96917 8.98321 +2715 6 26.0427 7.1974 41.5664 19.1127 -25.9459 -27.3591 +2716 4 26.6886 6.46136 41.6822 -6.92827 19.3426 1.38611 +2717 4 25.5576 7.23966 0.456505 -11.7101 6.8047 33.8929 +2718 6 22.0248 3.60461 29.0185 -16.0846 7.25678 -9.40108 +2719 4 21.194 3.80897 28.5456 14.569 -4.87522 0.502932 +2720 4 22.1959 4.40114 29.525 4.81678 0.210141 7.58007 +2721 6 27.8548 32.5394 20.644 30.2008 -27.0251 30.2495 +2722 4 26.9598 32.7332 20.4747 -36.3343 12.7784 -11.814 +2723 4 28.412 33.1097 20.1287 0.615935 11.6015 -11.5439 +2724 6 8.3956 24.7909 3.45677 41.8783 30.6212 2.1827 +2725 4 8.85983 24.2427 2.83372 10.4085 -11.4169 -11.9204 +2726 4 7.65564 24.3184 3.74512 -41.6031 -24.257 6.19876 +2727 6 30.5856 41.7288 15.6573 18.8319 11.6475 40.5199 +2728 4 29.9513 0.161741 16.3149 8.82373 -8.1621 -4.69308 +2729 4 30.0935 41.6309 14.8822 -24.2072 -8.84927 -42.274 +2730 6 48.0984 5.63232 21.2085 -24.8678 -8.67647 -10.7387 +2731 4 47.6235 6.28714 20.6867 8.63769 7.09972 -0.446275 +2732 4 47.3595 5.05066 21.4474 12.3779 0.983941 9.20385 +2733 6 39.4236 23.163 35.7324 -26.6807 -22.8308 -31.4054 +2734 4 39.8477 23.6904 36.3502 31.9199 30.6139 46.0523 +2735 4 38.8623 22.5516 36.2186 -1.29306 -3.58423 7.04543 +2736 6 51.5883 33.3617 5.78995 -19.5798 -55.0773 -18.3228 +2737 4 51.7861 34.2574 5.89467 9.96767 53.6603 7.25336 +2738 4 51.5145 33.1869 4.82901 1.99858 6.27826 11.2132 +2739 6 40.1205 17.6413 30.7797 3.51386 -32.8888 9.0941 +2740 4 39.6335 18.3955 31.0853 6.47279 10.0891 -2.42254 +2741 4 40.8254 17.9321 30.1952 -5.08805 1.72673 -6.80625 +2742 6 46.4235 9.81086 18.5807 -13.6096 13.2326 25.0066 +2743 4 47.164 10.4099 18.4597 3.17276 -2.49269 -0.272695 +2744 4 46.3941 9.2422 17.832 2.02048 -17.819 -25.0993 +2745 6 15.8844 41.0843 31.9336 24.9021 -3.26155 -16.7898 +2746 4 16.5805 40.7078 31.3592 -9.31569 -10.1627 6.74042 +2747 4 16.1791 0.090931 31.8861 -11.051 9.97246 9.22539 +2748 6 48.5496 25.7276 14.9325 -23.4699 4.48431 -20.1118 +2749 4 49.4421 25.9075 14.7294 36.7388 1.67727 3.80263 +2750 4 48.1707 25.827 14.039 -11.0362 0.596064 15.3478 +2751 6 39.2225 28.9892 36.1575 1.81804 -9.3363 -11.5399 +2752 4 40.0459 29.1043 36.6225 6.32097 13.8964 11.0865 +2753 4 39.5169 28.7877 35.2623 -5.25992 -5.15898 -10.721 +2754 6 37.325 21.0738 14.9394 -7.85324 -20.9229 -64.7065 +2755 4 37.9996 20.7799 14.2865 -1.58038 10.9233 26.036 +2756 4 36.5898 21.2349 14.28 11.1979 5.88457 46.2171 +2757 6 32.4971 22.8607 15.7433 -7.91212 -33.4559 24.7905 +2758 4 31.7632 22.4534 15.25 1.55934 10.0805 -2.32687 +2759 4 32.5592 22.2921 16.5663 4.31702 21.463 -27.4441 +2760 6 18.5773 8.13014 37.5708 2.8796 34.5567 21.0854 +2761 4 19.1021 8.93687 37.8089 1.20854 -19.8484 -10.1251 +2762 4 17.9431 8.09722 38.288 -3.97249 -3.14491 3.87795 +2763 6 46.9308 30.3817 11.0144 7.20248 -9.32119 -46.6603 +2764 4 46.4987 30.7035 10.1833 6.25688 -3.94108 30.979 +2765 4 47.431 29.6318 10.6212 -6.26387 6.19468 23.2459 +2766 6 54.6355 13.051 30.6677 -0.631529 -12.3617 0.377161 +2767 4 54.9401 12.1973 31.0202 -4.70537 6.73717 3.83911 +2768 4 54.6706 13.679 31.4001 -0.542159 7.57402 -2.77471 +2769 6 32.2973 35.1412 27.9506 0.702746 7.41177 51.9011 +2770 4 32.3519 35.6753 28.7977 -4.11304 1.55554 -34.3644 +2771 4 32.0809 34.2722 28.2835 1.42742 -15.3938 2.35714 +2772 6 4.45353 25.396 31.7914 -28.2716 -32.1048 1.32297 +2773 4 5.00928 24.905 32.4172 3.79617 9.45861 3.32159 +2774 4 4.83781 26.2295 31.6234 26.2458 34.1175 0.407684 +2775 6 40.7781 38.1509 21.8521 -13.1408 -33.509 11.5706 +2776 4 40.6716 39.044 22.1698 7.33695 21.0707 -1.24628 +2777 4 41.4481 38.0623 21.1738 10.5508 14.8215 -9.14642 +2778 6 26.6931 9.85845 27.4042 -43.8759 24.145 24.882 +2779 4 26.9952 9.1619 26.8761 23.7363 -35.7414 -23.7206 +2780 4 25.7673 9.60487 27.6152 14.5566 8.07269 5.62533 +2781 6 53.3967 39.4485 11.7649 68.843 -10.0355 -14.0333 +2782 4 54.4148 39.3855 11.5456 -53.2103 8.20916 12.7106 +2783 4 53.105 40.2482 11.2866 -1.29569 -7.05369 14.3337 +2784 6 35.3292 21.4155 2.23587 15.106 -7.83484 -18.4876 +2785 4 34.912 20.5764 2.48744 -1.27765 6.93695 -0.309601 +2786 4 35.8084 21.2289 1.37944 -21.1629 3.53466 26.6292 +2787 6 4.14409 17.1449 33.9131 -16.1644 -22.9901 22.0601 +2788 4 4.14131 16.4411 34.6063 8.69636 10.7601 -14.4963 +2789 4 3.20404 17.192 33.6728 6.06844 1.20479 -9.99864 +2790 6 24.1486 16.1886 14.6752 2.90394 -28.6462 -21.9437 +2791 4 24.2343 17.059 15.0346 0.494679 15.8947 1.83084 +2792 4 23.7735 16.3203 13.7888 -2.47926 -0.947779 4.85435 +2793 6 43.1303 2.83022 26.0988 7.42094 18.4339 -15.1049 +2794 4 42.3152 3.21229 26.4285 -6.54764 -1.84254 4.96768 +2795 4 43.2129 3.23454 25.2082 4.91034 -11.1878 11.8147 +2796 6 40.68 12.1827 1.56051 12.2683 5.96873 16.2718 +2797 4 41.5968 12.2158 1.84207 12.0551 -6.37233 -9.83141 +2798 4 40.2741 12.5174 2.36876 -21.9125 -2.35909 -10.0625 +2799 6 47.3781 8.09655 26.7608 82.0606 26.064 -7.54845 +2800 4 46.666 7.67998 26.3919 -67.6244 -33.3987 -26.4118 +2801 4 48.0445 8.01522 26.0221 -12.6559 5.80771 33.8866 +2802 6 35.8947 30.7223 38.5098 17.2216 52.6179 -38.6143 +2803 4 35.6523 29.9703 39.0072 10.7188 -28.2359 27.6772 +2804 4 36.8587 31.0199 38.5623 -37.3038 -25.1724 3.03639 +2805 6 51.3054 23.2176 32.4969 -40.2617 11.1267 -4.72183 +2806 4 51.571 23.9803 31.9692 8.10126 9.10595 3.65824 +2807 4 52.0738 22.7076 32.6523 27.5758 -14.8312 4.00399 +2808 6 30.6066 4.44965 39.6625 0.615077 -4.04577 -5.4494 +2809 4 30.9728 3.64581 40.0124 3.38991 -22.1323 -0.234101 +2810 4 30.7691 5.02119 40.3987 0.467535 29.3806 6.08815 +2811 6 35.2584 29.6988 2.86074 -18.8762 -20.4699 -30.2285 +2812 4 35.7444 29.7805 2.00551 -3.31399 -2.84145 17.507 +2813 4 34.478 29.0852 2.62897 29.9452 30.586 13.9144 +2814 6 50.3064 26.1399 9.38994 -11.2342 14.6262 -3.47403 +2815 4 49.9288 26.8854 8.86032 11.0364 -25.2497 6.23881 +2816 4 49.6695 25.4035 9.37359 7.94529 9.32604 -3.86417 +2817 6 50.1026 36.8163 26.4125 -14.5138 -5.51826 -11.285 +2818 4 49.5888 36.0167 26.6617 3.79204 13.187 5.56915 +2819 4 50.2319 37.3727 27.1922 -3.20057 1.11223 6.19844 +2820 6 40.3045 23.9511 38.5442 56.3682 27.7758 -3.16545 +2821 4 40.8125 24.7624 38.7991 -6.5383 -29.3065 -12.768 +2822 4 39.4568 24.2221 38.8139 -44.6373 -1.162 12.0349 +2823 6 24.9504 10.7612 30.6561 23.3702 -4.90777 36.4738 +2824 4 25.6234 10.7245 31.4083 -25.7901 9.07318 -40.0098 +2825 4 24.9126 11.6687 30.2959 1.4184 -10.5997 2.42613 +2826 6 5.89627 1.02238 5.41014 -10.9637 -3.10309 -8.95081 +2827 4 5.14436 0.409378 5.47088 11.7326 -0.810065 6.31118 +2828 4 6.70289 0.529043 5.60145 -0.696658 -1.4992 -0.407558 +2829 6 44.282 29.3718 26.2736 69.4655 -24.0165 25.5627 +2830 4 43.5561 29.7046 25.8233 -49.9183 11.7173 -34.3685 +2831 4 44.8903 28.8623 25.6892 -19.9675 5.54095 9.74148 +2832 6 25.3119 10.1784 6.67292 -15.7736 -23.3412 -3.06725 +2833 4 25.6521 11.0537 6.64576 10.6351 24.7362 -4.37451 +2834 4 25.4625 9.79379 5.79618 6.21987 0.326131 1.26241 +2835 6 13.3514 28.0662 2.56722 45.2358 13.6418 17.9819 +2836 4 12.4545 27.8107 2.56105 -32.9681 -11.4511 -11.8173 +2837 4 13.8041 27.7134 1.79344 -6.10921 -0.687749 -0.120894 +2838 6 6.44709 40.2351 18.0254 21.2427 9.30891 -1.39987 +2839 4 6.966 39.4726 17.7533 0.137807 -7.29984 6.20872 +2840 4 5.59682 40.0602 17.6456 -22.1821 0.316247 -4.7234 +2841 6 47.7944 13.5061 2.01255 -17.6425 -30.8617 30.605 +2842 4 48.2016 12.6358 2.19438 -7.04124 7.54818 -3.24284 +2843 4 48.4122 13.9735 1.50015 28.8905 20.8749 -24.4455 +2844 6 13.5944 20.2974 2.4458 20.0315 11.2691 18.6487 +2845 4 13.7883 19.6075 3.10831 1.39134 9.87367 -8.40212 +2846 4 13.0064 19.8713 1.85297 -21.5499 -10.3053 -19.2062 +2847 6 15.2336 0.850818 36.6661 8.37652 40.6516 -23.9146 +2848 4 15.3117 1.46746 37.4264 -6.40063 -24.0213 -7.24367 +2849 4 15.3514 1.51981 35.909 -6.71396 -40.605 26.1829 +2850 6 33.5971 35.2491 15.0847 71.6425 -10.6997 11.4711 +2851 4 33.8969 35.3297 16.0058 -20.0956 -0.49545 -2.4869 +2852 4 34.508 35.0431 14.6807 -47.978 4.31732 -2.67502 +2853 6 21.7981 9.23698 0.429299 24.0185 -25.5324 29.6504 +2854 4 22.426 9.07175 41.6424 8.6426 -4.20457 -11.04 +2855 4 21.1884 9.81045 0.032847 -35.1273 25.1593 -17.3244 +2856 6 38.1453 27.4709 3.0333 47.9463 -55.6761 10.6859 +2857 4 37.7532 27.3037 2.19157 -17.0599 1.14667 -24.2168 +2858 4 37.8405 28.2288 3.44687 -27.291 50.0057 16.1216 +2859 6 38.8714 27.215 11.7709 41.141 -36.7506 -15.3879 +2860 4 38.9285 26.3434 12.2193 -14.3396 10.7389 0.963039 +2861 4 39.5886 27.0941 11.0922 -22.6073 11.6268 16.0227 +2862 6 29.8734 41.5737 28.6987 15.2279 35.2113 -10.5566 +2863 4 28.9552 41.3162 28.7047 -13.1778 -5.77603 2.88395 +2864 4 29.9141 0.263017 27.9132 -0.896253 -12.9147 16.3719 +2865 6 34.03 8.70777 38.0687 38.5763 27.6628 16.1728 +2866 4 34.8607 8.18924 38.1985 -14.88 11.0383 -8.6682 +2867 4 33.3419 8.15213 37.7593 -24.3719 -27.4308 -8.08559 +2868 6 38.8091 27.3495 30.6738 6.32435 -21.1782 -4.52762 +2869 4 38.5154 26.4386 30.4378 -1.34454 21.7952 1.35616 +2870 4 38.3686 27.5808 31.4849 -11.9448 1.82739 7.69603 +2871 6 41.6473 17.269 36.3639 7.45605 15.5752 1.52238 +2872 4 41.3137 17.162 35.483 -10.4634 0.342165 -15.0979 +2873 4 41.7169 16.3923 36.7151 5.72978 -18.5967 8.16978 +2874 6 30.7243 26.977 35.2074 -15.5404 -28.2563 -3.1326 +2875 4 31.3953 27.4345 34.7177 18.5093 15.4635 -5.31058 +2876 4 30.2206 27.5565 35.766 -0.690558 20.2492 9.56945 +2877 6 47.5414 4.09198 27.2867 -2.42911 13.6608 18.2544 +2878 4 46.636 4.37242 27.4325 -10.4037 -2.52064 9.15115 +2879 4 47.5606 3.99786 26.3497 6.55325 -3.96267 -23.0579 +2880 6 20.946 8.39203 7.27322 -27.8597 -45.7319 -0.818331 +2881 4 20.9365 8.74812 8.15774 -0.207227 20.4039 13.5637 +2882 4 21.4094 8.93893 6.67191 21.7448 31.5979 -18.7028 +2883 6 36.8544 13.691 0.855516 -6.96494 -6.58957 -4.7536 +2884 4 37.3845 13.474 1.605 15.5913 2.53244 29.7992 +2885 4 37.0002 12.9032 0.328977 -4.78774 -2.28905 -12.5933 +2886 6 28.5904 20.2994 26.4544 16.2695 -3.42806 -15.5352 +2887 4 28.4835 19.402 26.1318 -1.12761 -3.3858 2.90642 +2888 4 27.7814 20.5406 26.8733 -22.93 6.76513 15.2817 +2889 6 51.6079 16.8571 33.5121 -4.50033 -4.43314 5.93611 +2890 4 51.6159 16.0837 34.101 -3.91985 -0.958274 -7.09147 +2891 4 50.9053 16.6875 32.8669 7.1497 -2.58651 -2.16023 +2892 6 16.2715 32.0073 37.6936 -41.8913 -21.032 -18.7972 +2893 4 16.4093 31.405 38.4555 0.0363557 12.0183 -19.687 +2894 4 15.4977 31.6058 37.1477 38.3353 16.8511 22.6146 +2895 6 14.3407 25.877 13.2155 1.26588 11.3619 -17.2713 +2896 4 13.5013 26.0279 13.6901 5.40221 7.27027 -0.947788 +2897 4 14.4551 26.5608 12.5093 -9.57117 -0.277473 20.5459 +2898 6 54.9749 28.8768 3.30374 1.15612 -53.5629 -1.59986 +2899 4 54.8083 28.9028 2.3467 2.04661 0.129141 5.0455 +2900 4 0.26744 27.9124 3.48546 -12.4506 41.1861 -2.95604 +2901 6 17.22 5.15598 2.57931 -12.7888 -35.846 -9.7104 +2902 4 17.8674 4.52191 2.91459 -1.87097 -9.90488 -4.08214 +2903 4 17.421 5.9071 3.09191 1.36943 25.6696 10.0797 +2904 6 50.6995 33.0507 10.3154 6.59719 15.9916 42.5002 +2905 4 50.6222 33.8517 9.79386 -1.28667 2.08485 -11.8542 +2906 4 50.7575 32.2667 9.79209 -3.80283 -15.7636 -22.9095 +2907 6 28.8826 19.8405 32.3742 18.5732 17.2051 -15.397 +2908 4 29.8373 20.0763 32.2 -31.4986 -11.6613 7.66973 +2909 4 28.4094 20.6578 32.1253 1.55933 -8.77069 7.582 +2910 6 22.4307 12.8248 23.2991 -20.6917 10.5217 33.6658 +2911 4 22.5556 12.3422 24.1574 -2.40655 13.6672 -16.3005 +2912 4 21.7108 13.488 23.4947 18.3613 -16.8762 -11.246 +2913 6 54.7763 15.5394 8.86893 2.10476 3.1215 13.1486 +2914 4 0.465115 15.309 9.51431 10.762 -2.70861 -3.02895 +2915 4 53.9989 15.1653 9.30174 -3.31272 -0.629746 -12.248 +2916 6 10.4518 19.2967 26.1704 43.67 -11.1159 60.7251 +2917 4 11.2502 18.7163 26.2348 -22.5321 13.8961 -6.48776 +2918 4 10.166 19.2541 25.3007 -24.1973 -3.18459 -58.4054 +2919 6 38.6496 20.2998 35.2325 20.2193 -0.813999 -8.63065 +2920 4 39.5955 20.3672 34.9603 -17.6326 -1.16496 9.70871 +2921 4 38.5782 19.6093 35.9099 2.97533 6.68842 -2.65526 +2922 6 17.4906 18.0487 15.2499 -10.3405 45.0299 20.0184 +2923 4 17.3837 17.5615 14.4531 -8.22833 -15.0257 -32.2828 +2924 4 17.2318 18.9864 14.9797 13.5676 -28.3997 10.204 +2925 6 29.6331 0.960567 26.2796 -25.6031 -26.3316 -72.4206 +2926 4 29.3216 1.74647 25.7973 3.40072 6.61544 23.4347 +2927 4 29.2407 0.266373 25.6265 23.6279 16.4272 47.4057 +2928 6 30.4665 12.6849 28.2971 -10.7965 -27.9245 1.17671 +2929 4 29.8272 13.0822 27.7097 -1.40549 16.7134 -9.61387 +2930 4 30.1324 11.7665 28.3519 9.60572 9.94425 5.65357 +2931 6 36.6695 22.1225 33.3577 39.6017 -11.6369 -25.7224 +2932 4 37.5338 21.6663 33.4931 -10.4393 24.3252 -8.31461 +2933 4 36.1732 21.6976 34.0074 -34.1256 -9.27026 38.9845 +2934 6 34.8672 22.4666 14.3113 -12.0535 -16.0605 -66.2467 +2935 4 34.0349 22.4515 14.7407 -19.1997 11.5289 38.0952 +2936 4 34.5417 22.174 13.4128 25.6484 2.69091 24.3313 +2937 6 15.5262 9.60919 7.44527 49.3682 -27.3699 -19.0187 +2938 4 16.547 9.52246 7.26069 -54.7763 6.57045 5.33777 +2939 4 15.1277 8.71762 7.26288 7.76902 16.5773 17.8238 +2940 6 21.8158 28.0339 19.8054 -4.91607 2.79332 -16.2053 +2941 4 21.8614 28.4614 20.6522 -2.04715 7.82991 15.4338 +2942 4 20.8734 27.9328 19.6183 -0.9528 -10.4666 6.26348 +2943 6 34.5348 24.4247 2.43569 30.4222 -68.2311 14.7367 +2944 4 34.4753 23.4054 2.32054 1.69344 45.6403 0.121788 +2945 4 35.3397 24.4934 3.03523 -29.9154 15.8849 -16.545 +2946 6 12.599 20.9348 33.4989 -13.8827 -5.0407 19.8786 +2947 4 11.7591 20.6911 33.9854 14.8004 1.51093 -27.4282 +2948 4 12.4712 20.9089 32.5331 -6.4324 -2.96843 13.903 +2949 6 45.7737 31.1538 8.70434 -2.26925 11.3362 1.64289 +2950 4 45.9542 32.0869 8.96415 -8.39554 -11.7705 -15.6468 +2951 4 44.8313 30.9442 8.82297 5.93432 7.3758 2.64979 +2952 6 15.4817 22.5529 30.1787 5.69125 -30.6905 2.54506 +2953 4 16.2669 22.9885 30.4865 5.73919 23.8488 1.47991 +2954 4 15.7828 21.6299 30.2043 -15.5749 7.04719 -4.74998 +2955 6 39.7421 17.1743 38.4094 21.5551 17.0277 -9.47446 +2956 4 39.5031 16.7163 37.59 -3.21419 -6.16335 13.1695 +2957 4 40.5012 17.7258 38.123 -12.3818 -10.233 9.13463 +2958 6 13.9944 24.6739 0.675362 16.6213 17.4065 1.77653 +2959 4 14.3534 24.6315 1.57006 -7.52322 -5.04497 4.60086 +2960 4 14.2363 25.5684 0.403337 7.11699 -3.23043 -4.31609 +2961 6 31.5223 19.5616 3.57151 -53.5885 6.24325 20.3398 +2962 4 30.9852 19.2876 4.35912 8.49606 10.2921 -25.2864 +2963 4 32.3806 19.3906 3.88708 44.0272 -8.41539 -5.41474 +2964 6 36.1052 25.07 19.4414 -58.1964 5.4792 30.944 +2965 4 37.0178 24.9674 19.4291 53.7837 8.57858 1.17104 +2966 4 35.8724 24.6048 18.6565 -11.4284 -6.26335 -25.0938 +2967 6 51.6856 17.6883 14.8068 3.37141 18.4291 36.2611 +2968 4 51.7159 18.5692 15.274 12.631 -26.1695 -13.2311 +2969 4 51.0805 17.8845 14.1157 -15.036 4.32684 -29.7308 +2970 6 37.7054 27.4905 38.1961 21.1085 51.9404 -4.50496 +2971 4 37.7442 26.8536 37.5026 -5.7586 -24.9449 -15.2301 +2972 4 38.1753 28.2651 37.7886 -14.569 -23.1779 14.5181 +2973 6 34.7911 13.8542 30.7834 63.814 8.34946 -38.9004 +2974 4 35.1479 14.6416 31.2053 -8.52888 3.60926 11.6955 +2975 4 33.9958 13.5796 31.1473 -54.5977 -12.3598 32.1143 +2976 6 19.6332 37.3754 39.9698 -24.3625 -2.8653 -8.02349 +2977 4 20.5737 37.5051 40.1221 10.6449 -2.37562 -1.97502 +2978 4 19.476 36.9037 39.1231 9.83703 4.21653 7.37417 +2979 6 40.9393 34.0697 21.4586 2.1394 -11.0927 -27.2527 +2980 4 41.1855 34.0244 22.3739 -0.995015 -5.02364 12.6588 +2981 4 40.8269 33.1391 21.1809 -5.56645 12.5591 1.05516 +2982 6 32.9542 27.2131 26.5676 21.8236 31.3611 42.3808 +2983 4 33.7455 27.7378 26.9411 -38.3522 -19.3744 -9.62352 +2984 4 33.2804 26.8388 25.7801 14.7034 -8.88898 -37.5519 +2985 6 24.4045 18.6625 15.6046 15.6323 5.3487 0.0952382 +2986 4 23.6496 19.2317 15.7207 -14.8084 -1.4602 1.41466 +2987 4 24.5649 18.2576 16.462 -0.219489 -3.50303 9.55317 +2988 6 29.9663 1.63299 9.06934 -19.1782 58.0281 -13.4952 +2989 4 30.0652 0.728361 9.20589 6.15764 -53.3299 8.23098 +2990 4 29.142 1.69178 8.53744 13.8409 -0.846673 8.85197 +2991 6 31.4884 20.0987 7.87879 28.0207 -11.7442 -56.0977 +2992 4 31.929 19.6692 7.07379 -7.62771 20.3934 38.6055 +2993 4 30.8102 19.4535 8.0257 -16.4635 -8.90407 20.6678 +2994 6 35.0404 3.79156 33.2694 -1.07326 -4.91424 22.8916 +2995 4 34.2545 4.23611 32.9039 10.815 -2.65177 -4.17514 +2996 4 34.969 3.91026 34.2418 -2.62674 -1.77539 -18.1187 +2997 6 43.9504 7.96546 12.9857 17.1829 -21.9111 0.113786 +2998 4 43.3325 7.29581 13.3448 8.44862 12.3123 -3.96012 +2999 4 43.4563 8.73573 12.7333 -15.1408 11.4953 0.0339333 +3000 6 44.1156 32.6759 16.9403 5.31814 23.9263 4.94933 +3001 4 44.7028 33.4557 16.8081 -6.11209 -18.3833 -3.28173 +3002 4 44.1603 32.5425 17.8901 -3.26507 -3.06823 6.73624 +3003 6 40.6044 27.171 19.0399 5.35236 -7.54795 -39.8413 +3004 4 39.9756 26.4797 18.7399 3.73803 11.5815 8.49028 +3005 4 41.0398 27.5246 18.2027 -12.4172 -8.32437 32.3474 +3006 6 46.047 23.2024 29.047 17.2683 37.2743 26.3298 +3007 4 46.6657 23.8797 29.4684 -18.5589 -27.346 -17.4569 +3008 4 46.486 22.3548 28.9238 8.34839 -6.65718 2.80441 +3009 6 42.6215 30.6103 18.862 -5.01232 -15.325 -26.4249 +3010 4 43.5272 30.7476 19.0895 18.324 11.0008 12.4889 +3011 4 42.704 29.9429 18.1625 -17.0641 3.12823 2.85026 +3012 6 36.1251 10.8932 23.2678 23.6581 36.1082 4.04534 +3013 4 35.2523 11.2865 23.1129 -2.80799 -1.69562 1.02392 +3014 4 36.6983 11.6913 23.4963 -28.2294 -33.6871 -7.78786 +3015 6 13.7386 31.5223 15.7271 -4.49361 3.73805 -16.8081 +3016 4 14.6779 31.7192 15.7387 3.94655 -1.56597 5.72926 +3017 4 13.381 32.0318 14.979 -1.5565 -4.12563 8.0657 +3018 6 33.1703 41.4275 27.7797 10.5813 -15.702 68.4674 +3019 4 32.9714 0.101499 27.0951 -7.66273 31.9341 -41.1766 +3020 4 33.2579 0.043937 28.6255 4.60937 -17.5422 -27.6682 +3021 6 32.9019 22.9042 31.4856 -22.5274 37.748 -5.90861 +3022 4 32.2895 23.1741 30.7829 6.44322 -22.1433 -13.1277 +3023 4 32.7242 23.6662 32.0583 13.0029 -8.58894 11.8377 +3024 6 27.6559 16.8629 6.38841 0.759442 -6.33883 29.8789 +3025 4 27.8611 17.2083 5.54221 8.69809 17.4791 -25.8043 +3026 4 26.8031 16.4594 6.24591 -13.957 -6.38022 2.63501 +3027 6 47.2651 11.6173 26.0576 8.33461 35.0159 47.6166 +3028 4 47.0912 11.6838 27.0214 -5.10661 -22.4254 -22.6877 +3029 4 47.7461 12.4597 25.9756 -3.10554 -9.06377 -24.8427 +3030 6 27.5595 7.06242 7.64189 36.0057 -29.1625 5.70238 +3031 4 26.7484 7.49683 7.83093 -25.0876 11.7282 17.2448 +3032 4 28.0841 6.86482 8.45622 -15.7481 15.6684 -17.1357 +3033 6 39.8009 9.06823 11.973 -19.1879 4.0297 -12.8881 +3034 4 39.4826 9.27056 11.0665 6.39012 -4.37616 15.6201 +3035 4 38.9894 9.1094 12.5089 2.28999 7.64442 -1.09803 +3036 6 18.1977 33.4656 36.103 -47.2434 1.22325 7.58723 +3037 4 17.6693 33.9565 35.4324 13.0563 -6.22307 9.58411 +3038 4 17.491 33.069 36.7104 31.5801 5.82297 -20.8408 +3039 6 37.1917 26.5507 0.720984 -4.45309 15.6177 5.32368 +3040 4 37.3846 25.6567 0.44907 -1.85313 -8.64798 -1.56679 +3041 4 36.2207 26.6114 0.739208 8.96605 -1.46339 -9.13916 +3042 6 44.1887 19.6251 36.8885 40.0452 -6.58607 -3.19327 +3043 4 45.0262 19.1233 36.6753 -25.2412 9.90919 11.1214 +3044 4 44.4881 20.5478 36.9825 -7.95545 -4.32402 -1.12283 +3045 6 27.7744 6.35339 35.6933 13.1235 -8.00403 1.40836 +3046 4 27.1655 6.97567 35.3121 -8.4989 9.93248 -6.95364 +3047 4 27.2748 5.53908 35.7675 0.865215 -2.72076 5.22838 +3048 6 34.7673 16.4826 20.8897 25.0208 -26.1622 5.09639 +3049 4 35.5801 15.8751 20.9364 -40.3091 28.8833 0.638889 +3050 4 34.1629 16.1653 21.5964 8.34467 8.45669 -12.6288 +3051 6 39.0349 20.9701 40.4369 -35.0548 -83.2732 -20.3586 +3052 4 38.7355 20.0763 40.8679 21.616 52.9309 -20.1646 +3053 4 39.3277 21.5521 41.0958 10.956 28.6509 41.127 +3054 6 10.8075 27.9275 1.66251 45.0798 11.5101 -39.3642 +3055 4 10.1207 27.6506 2.20454 -46.3214 -11.9312 37.0665 +3056 4 10.864 28.8887 1.77269 -0.956148 -2.75571 -0.87801 +3057 6 47.0235 23.1304 13.2457 -34.1648 -14.46 -9.62139 +3058 4 47.6809 23.5773 12.718 7.19949 7.22116 -4.18429 +3059 4 46.2703 22.9258 12.6132 27.3011 3.73645 28.26 +3060 6 34.5862 28.4037 10.6629 -11.4192 -4.75939 1.42695 +3061 4 34.4799 27.7252 11.3319 -5.35328 -3.69815 4.40234 +3062 4 35.5403 28.4214 10.6073 9.29856 11.2923 -14.2157 +3063 6 3.3474 17.5828 14.2796 -19.4871 24.8451 -12.2706 +3064 4 3.54237 16.6973 14.5399 7.15819 -24.2504 13.4427 +3065 4 3.84281 18.1577 14.8755 9.98901 -5.90389 -1.38432 +3066 6 27.7213 11.5993 7.52196 5.39723 39.0715 -5.17771 +3067 4 27.6701 12.604 7.61024 4.43832 -37.6789 -1.1729 +3068 4 27.2296 11.2227 8.25132 -2.72363 -3.1191 8.53492 +3069 6 41.4314 28.3382 9.01837 19.0589 -0.973961 -18.7609 +3070 4 40.8555 28.7961 9.62238 -6.75468 20.1798 6.66135 +3071 4 41.7073 28.957 8.28743 -10.8025 -14.2077 17.7393 +3072 6 42.0854 4.7797 8.18851 -21.257 14.5957 -52.3899 +3073 4 42.0432 5.70949 7.81908 14.9695 -22.9802 20.9203 +3074 4 41.8649 4.22501 7.38905 12.6142 12.8494 32.4876 +3075 6 28.4682 8.6325 40.3242 -61.7219 6.47809 -5.55454 +3076 4 27.7379 8.57122 40.9835 27.869 -4.13123 -2.00049 +3077 4 27.8882 8.69791 39.5144 34.8971 -1.31486 9.68376 +3078 6 0.711352 18.2475 15.2828 -1.03732 14.0577 26.4962 +3079 4 1.6037 18.2498 14.9622 18.0256 -6.96047 -13.9963 +3080 4 0.201613 17.7329 14.6701 -10.6254 -13.4061 -11.9404 +3081 6 7.11345 16.2289 40.4432 8.45023 -35.9074 47.1296 +3082 4 7.17312 15.3057 40.7986 -0.221024 11.0765 -27.8146 +3083 4 7.22051 16.6703 41.3088 -5.23596 22.4775 -22.5048 +3084 6 41.0858 8.62552 20.9048 11.0684 -11.3616 26.0286 +3085 4 40.3918 8.42716 20.2762 -10.0062 9.73992 -12.3328 +3086 4 41.3944 9.53753 20.8124 -4.81268 6.06535 -10.7329 +3087 6 31.7073 7.42286 37.542 -14.8479 -9.90339 6.69006 +3088 4 31.4959 7.12404 36.6506 2.47263 0.526998 -6.01676 +3089 4 30.9335 7.11441 38.0458 14.4773 7.59586 -0.291785 +3090 6 40.7266 11.6476 25.425 -35.4896 13.4329 -16.1803 +3091 4 40.7395 12.5913 25.6925 9.9362 -18.5419 -7.18222 +3092 4 41.5423 11.2236 25.6435 22.7694 -4.71413 12.394 +3093 6 29.8665 30.1579 6.66307 26.6562 -4.16721 8.5177 +3094 4 30.5555 30.7343 6.31583 -2.18777 1.73834 -10.5199 +3095 4 30.3573 29.3259 6.76714 -13.2281 -1.59651 -6.45815 +3096 6 40.8439 24.5837 5.68012 15.8615 33.1962 -4.14396 +3097 4 41.3457 25.4223 5.9023 -8.27611 -29.5734 -8.52614 +3098 4 40.1119 24.5659 6.27901 -12.3156 -1.80355 11.8721 +3099 6 34.3917 9.09675 20.4219 17.6262 -1.15942 17.9162 +3100 4 33.57 9.43601 20.7884 -5.86563 4.88571 -3.34935 +3101 4 34.2167 8.80099 19.5352 -13.2656 -6.03918 -15.2606 +3102 6 18.2311 33.5548 26.5354 9.60899 -55.578 -54.4315 +3103 4 19.159 33.2107 26.4405 -23.3884 24.4218 8.45675 +3104 4 18.1621 34.044 27.3085 3.33799 34.4716 53.9641 +3105 6 28.9072 17.4193 26.7965 8.90265 -1.34032 10.3526 +3106 4 28.3267 16.8801 26.2506 -9.53448 5.67773 -5.57268 +3107 4 28.3756 17.7646 27.5432 9.63981 -8.23286 -8.72686 +3108 6 50.4255 35.5446 18.192 14.112 9.6817 -2.74072 +3109 4 50.5661 35.3326 17.2487 -8.6314 -7.47676 15.7559 +3110 4 50.5766 34.7477 18.7329 -11.9848 3.75846 -10.2286 +3111 6 2.99463 21.5653 31.4474 1.68271 -21.0005 -22.757 +3112 4 3.33698 22.262 30.8385 -11.1525 -11.1618 12.076 +3113 4 2.83901 20.7479 30.8788 5.9339 29.1288 19.4027 +3114 6 36.1811 18.7457 8.60665 26.0746 50.7707 2.54435 +3115 4 36.1969 17.9289 9.04749 -6.79937 -48.2248 12.3681 +3116 4 35.6147 18.7828 7.85483 -18.853 -7.00319 -22.0811 +3117 6 20.2934 6.48366 33.7248 -33.7925 -21.1439 9.08779 +3118 4 19.8228 6.33509 34.5702 11.9648 11.0481 1.53323 +3119 4 19.9109 5.73333 33.234 17.8653 6.32962 -8.93867 +3120 6 14.0016 30.5326 6.65439 -2.06342 0.226434 14.1624 +3121 4 14.6658 31.0189 7.18657 -8.4774 -5.82658 -13.2159 +3122 4 13.1556 30.6664 7.11082 5.19683 1.19435 -6.65694 +3123 6 36.2738 16.4523 35.7634 28.7444 28.7466 -1.25628 +3124 4 37.2529 16.3082 35.8444 -30.8138 -2.80693 3.80535 +3125 4 36.1869 17.4417 35.6433 -1.25715 -33.4762 0.326736 +3126 6 45.8255 37.6646 9.68707 16.0609 -41.2042 -13.6418 +3127 4 45.4852 38.2919 10.2717 -20.4348 34.8513 25.7777 +3128 4 46.231 37.0083 10.2774 7.06244 2.74597 -12.4723 +3129 6 47.4229 17.9968 27.6368 -1.79372 -57.0164 -4.60636 +3130 4 47.566 17.432 26.8065 -4.8869 24.4286 27.8294 +3131 4 47.3631 17.3546 28.4089 6.87022 22.2846 -25.0829 +3132 6 25.9574 18.2976 0.964228 23.0858 -4.77958 -10.3735 +3133 4 26.3734 18.9022 1.60725 -19.9671 -4.02324 -2.33442 +3134 4 24.9961 18.2982 0.948557 -9.32218 6.60301 10.8105 +3135 6 27.3657 22.4026 4.28337 1.04907 -15.9856 -17.2206 +3136 4 27.2658 23.3197 4.47064 2.83879 26.7243 10.1579 +3137 4 27.3462 22.4079 3.3181 -1.05974 -10.8362 7.50108 +3138 6 3.39902 3.84297 27.6033 -32.797 -16.937 8.3321 +3139 4 3.87422 4.64571 27.4715 26.6916 15.5682 -1.1402 +3140 4 3.96055 3.06079 27.6076 7.92228 2.5358 -5.38712 +3141 6 45.3564 27.6573 28.835 13.8657 -6.64535 19.4164 +3142 4 44.592 27.1099 28.6295 -10.1072 2.65107 -0.516215 +3143 4 45.3903 28.3299 28.161 -2.22034 5.33578 -9.67936 +3144 6 28.3928 32.384 16.2149 35.1766 -7.36337 1.61596 +3145 4 29.2284 32.2059 15.7054 -23.0821 5.0916 11.0276 +3146 4 28.7076 32.6186 17.1078 -8.03404 1.42552 -9.59962 +3147 6 9.90485 33.8293 13.0286 10.5996 -3.42126 36.647 +3148 4 9.63365 33.2371 13.7754 2.50037 15.8816 -14.8106 +3149 4 9.32864 33.6931 12.2897 -16.1444 -6.90665 -19.0975 +3150 6 38.3335 26.6343 14.9205 -0.551684 -24.4487 3.86314 +3151 4 38.658 25.7334 15.149 1.53578 20.736 -5.06851 +3152 4 37.3858 26.5974 15.0972 1.00556 4.30146 -0.183996 +3153 6 31.3571 16.3836 4.2445 -16.7299 -18.7641 16.8138 +3154 4 30.5501 15.9079 4.56795 14.9054 8.61271 -6.80276 +3155 4 31.2311 16.4593 3.29715 -1.72501 9.16645 -9.12782 +3156 6 6.17482 3.39637 6.55833 17.6941 29.4886 56.031 +3157 4 6.41103 3.08651 7.49149 -7.06328 10.7723 -41.2395 +3158 4 5.9143 2.63963 6.07247 -2.51266 -29.5732 -15.1374 +3159 6 42.5954 13 5.61529 2.6815 -10.2341 6.00586 +3160 4 42.2228 13.83 5.89445 -1.70762 9.74234 -1.3058 +3161 4 43.4476 12.9425 6.06763 3.18432 -3.38396 -9.63491 +3162 6 41.0469 31.4032 33.8032 -2.41258 31.7421 -2.74763 +3163 4 40.7074 31.3974 34.7214 7.44932 1.1292 -16.4995 +3164 4 41.1575 32.3688 33.5162 -1.31614 -41.8694 16.6901 +3165 6 52.8576 12.0626 26.2641 9.5895 -24.4248 -55.9842 +3166 4 52.4684 12.727 26.7939 -19.7064 26.0739 18.5009 +3167 4 52.6066 12.2568 25.3043 12.3637 -4.77707 33.6793 +3168 6 39.2086 4.29542 29.0724 8.4008 5.1904 -7.5125 +3169 4 38.4444 4.85752 29.2861 11.0986 -5.7068 1.32154 +3170 4 39.9986 4.64958 29.5231 -9.05665 -5.78587 -2.57989 +3171 6 3.65769 27.0104 11.285 -33.2394 -3.70913 -3.8751 +3172 4 4.59992 26.8829 11.3514 17.6792 2.33561 -5.11125 +3173 4 3.4519 27.7953 10.7423 10.2361 0.60791 3.91121 +3174 6 41.5441 29.6402 25.2654 2.79284 -4.6021 22.0238 +3175 4 41.8464 29.7038 24.3667 4.04268 2.71218 -16.2057 +3176 4 40.7127 30.1073 25.3399 -6.11251 5.69311 -9.79107 +3177 6 50.4754 27.4974 30.671 -6.87832 -12.1873 7.27551 +3178 4 50.0778 27.1279 31.4799 3.22248 2.82006 -4.01445 +3179 4 49.7824 27.9982 30.2275 0.0461655 4.73 -3.38362 +3180 6 32.7876 33.6322 41.7537 -8.7541 -8.89692 -39.0089 +3181 4 33.1671 32.7559 41.8028 5.47994 -11.5785 5.15438 +3182 4 32.9083 34.029 0.675063 4.83491 15.974 33.6037 +3183 6 5.9806 9.64323 7.93715 4.3965 6.41539 -15.2951 +3184 4 5.77829 9.93579 8.8312 0.6559 3.73469 4.68299 +3185 4 6.3228 10.4083 7.4265 1.56495 -8.59939 9.02132 +3186 6 52.7884 25.3949 27.7 -7.43266 -9.74322 -1.44878 +3187 4 52.93 26.351 27.8747 -0.851616 -24.8244 8.41831 +3188 4 52.9998 24.8518 28.4994 7.3809 16.2458 -18.9874 +3189 6 18.6796 23.2043 14.4609 8.49541 46.7244 28.1607 +3190 4 18.697 24.1166 14.872 -21.1178 -26.825 -16.729 +3191 4 19.5981 23.1771 14.2416 15.365 -21.3066 -15.3625 +3192 6 31.2857 9.07887 13.0786 26.2489 -54.2202 -11.3888 +3193 4 31.3193 8.20519 13.5416 -2.63874 16.5358 -10.154 +3194 4 30.7972 9.64602 13.6278 -24.9284 29.9413 31.6235 +3195 6 52.8163 16.833 29.9704 25.4684 -2.46115 -18.7711 +3196 4 53.1785 16.3479 29.2052 -11.8989 0.938692 6.7974 +3197 4 53.5445 17.4528 30.1342 -3.36222 3.81908 9.3955 +3198 6 13.4835 30.6533 11.9137 -46.9609 -12.8402 15.0292 +3199 4 12.8701 31.2475 12.4314 22.3442 -12.341 -15.3642 +3200 4 14.3315 31.0589 11.9363 20.4041 22.2607 2.0467 +3201 6 24.4145 24.6647 11.1793 -22.2983 -41.6602 -10.5575 +3202 4 25.2113 25.1208 11.3859 27.2622 9.38308 11.5927 +3203 4 24.6402 23.6908 11.0915 -11.4513 27.6962 10.6476 +3204 6 11.1203 26.798 5.92715 -0.288466 28.8994 -0.991584 +3205 4 11.4516 26.991 6.8143 4.21529 -7.59652 -0.673238 +3206 4 11.0194 27.7223 5.58288 -7.6649 -30.4822 0.0195949 +3207 6 12.0071 32.3096 4.57291 -4.86243 14.2275 -68.6847 +3208 4 11.7793 31.9281 3.63093 8.01684 14.4954 56.5286 +3209 4 12.2995 33.2463 4.37904 -4.11207 -26.5611 6.70158 +3210 6 6.4322 5.49281 30.4716 35.2368 -18.2726 5.22228 +3211 4 6.85856 6.3256 30.2181 -6.14256 4.86399 -3.96588 +3212 4 5.49729 5.53619 30.4137 -26.8093 16.306 -3.74387 +3213 6 38.1866 39.6 29.3849 -55.2477 -18.0227 -31.7741 +3214 4 37.4363 40.1798 29.0864 28.3626 1.3397 12.8196 +3215 4 37.8398 38.7214 29.0428 28.3274 26.4583 13.0641 +3216 6 52.5811 19.3636 5.41604 51.907 48.1011 -36.5249 +3217 4 52.4834 20.3242 5.17263 -20.1975 -32.0404 8.71389 +3218 4 53.4908 19.2453 4.99747 -31.6145 -20.6418 25.5541 +3219 6 18.3356 9.8205 21.0747 -17.6268 -29.6196 -17.636 +3220 4 17.8021 9.40634 20.3533 -1.88913 9.35392 27.897 +3221 4 19.0546 10.1733 20.5835 25.9839 20.5094 -7.72749 +3222 6 14.4924 41.1161 15.0432 10.1364 3.71296 -9.89663 +3223 4 15.2732 41.1462 15.6022 9.62288 -5.62086 4.10329 +3224 4 13.9031 41.7078 15.5102 -8.32301 1.75038 3.32266 +3225 6 35.9996 23.9069 26.7492 18.6837 -25.8156 -39.8793 +3226 4 35.9246 23.4421 27.5469 -8.45021 -0.659318 44.9575 +3227 4 36.3072 23.1381 26.2025 -8.08285 36.2837 5.17172 +3228 6 35.634 10.4286 26.2543 -16.0886 -36.8378 31.8954 +3229 4 36.0318 10.4196 25.4062 11.0324 6.64788 -31.8122 +3230 4 35.4344 9.46932 26.4326 4.10196 23.0818 -6.20158 +3231 6 45.3004 24.2842 20.2749 24.2383 10.4641 7.4623 +3232 4 45.3515 25.0535 19.6808 2.20237 -7.91345 -3.22769 +3233 4 44.5434 23.7522 20.0895 -20.4117 -5.11737 -13.922 +3234 6 15.8182 39.0515 24.2407 12.965 16.6456 0.954929 +3235 4 15.3741 39.8779 24.5544 7.5658 -17.411 -0.0196462 +3236 4 16.7724 39.3066 24.1247 -29.8541 -4.22386 6.92178 +3237 6 4.60659 25.9073 16.8122 1.83212 2.60998 -1.97709 +3238 4 5.31562 26.4095 17.2499 -5.00617 -6.2898 0.278133 +3239 4 3.79975 26.4302 16.9186 11.5163 2.87992 -0.585475 +3240 6 33.4767 9.9887 32.5701 -44.5277 -5.18869 -27.5725 +3241 4 34.322 10.1593 32.8843 54.6618 16.656 18.5178 +3242 4 33.0203 9.70843 33.3575 -8.70161 -12.0001 8.14623 +3243 6 22.9321 37.514 1.50284 -0.19108 -28.0604 17.8877 +3244 4 23.0149 38.2279 2.13297 1.92014 9.99004 7.14626 +3245 4 22.7552 36.7067 2.06858 1.19451 21.8657 -20.5647 +3246 6 39.1248 20.5474 25.4766 21.2332 -16.8391 26.0428 +3247 4 39.2186 21.3943 25.0643 2.22233 17.645 -5.02625 +3248 4 39.853 20.5019 26.1611 -16.83 0.667515 -19.8449 +3249 6 25.0699 25.071 37.6104 17.3941 16.9986 -26.7924 +3250 4 25.9994 25.4036 37.6322 -19.4928 -16.3283 1.07636 +3251 4 24.8822 24.8366 38.5108 -1.54859 -5.98321 18.8059 +3252 6 12.2108 35.7702 11.4211 -21.274 -0.450661 -24.3109 +3253 4 11.4942 36.1177 10.8268 17.2098 -2.57945 23.3101 +3254 4 12.7534 35.3113 10.7723 8.20233 4.40137 5.7707 +3255 6 42.0318 15.7212 20.1319 23.9789 -4.66934 -19.8056 +3256 4 42.573 15.4482 19.3354 -11.2719 11.6022 18.1956 +3257 4 42.3198 16.6222 20.3614 3.24172 -2.08619 -3.65764 +3258 6 53.203 25.4276 39.527 3.00787 -13.9161 6.63788 +3259 4 53.7641 25.8569 38.8977 9.18601 6.10619 -8.92001 +3260 4 52.4886 26.0297 39.6953 -12.4398 9.9207 3.51955 +3261 6 53.7999 21.7704 1.29423 13.4333 -6.07506 22.1965 +3262 4 54.6908 21.5389 0.969279 -9.57261 -3.1085 -1.99035 +3263 4 53.3016 22.2177 0.619486 -6.56312 6.61298 -22.2093 +3264 6 1.93757 22.4543 20.1748 -8.22485 -1.41006 19.3874 +3265 4 1.60089 23.2534 20.6505 8.04613 -19.7643 -7.74833 +3266 4 2.27012 21.8339 20.8623 2.42307 18.0741 -7.93574 +3267 6 41.1802 16.179 11.484 -8.24259 53.7733 14.6683 +3268 4 40.8475 15.3772 11.8508 -2.32532 -30.9762 7.10209 +3269 4 40.6167 16.8825 11.9353 16.6943 -22.3779 -21.294 +3270 6 17.1967 38.6113 9.60334 5.35995 -1.86267 -8.12923 +3271 4 17.7852 38.6361 10.3521 13.641 -0.452934 12.0217 +3272 4 16.3282 38.6029 9.98982 -18.6262 -0.708432 10.1602 +3273 6 33.1969 12.9538 38.5484 12.352 25.5713 -8.86638 +3274 4 33.6486 13.824 38.4674 -8.05485 -18.2555 -5.8969 +3275 4 33.0335 12.8861 39.4897 4.37007 -7.66636 -4.23751 +3276 6 24.7228 21.6957 39.9776 0.331302 -26.4697 -8.75647 +3277 4 24.5832 21.6143 39.0045 0.235774 0.581704 12.5709 +3278 4 25.2663 20.9218 40.2505 -4.0265 10.6546 -4.86064 +3279 6 13.577 15.5497 27.3411 27.7809 44.9786 27.5516 +3280 4 13.196 16.0821 28.0648 5.30872 -0.0493108 -10.0398 +3281 4 12.9031 14.935 27.2057 -29.8548 -39.4113 -11.0219 +3282 6 24.6863 18.7248 9.26482 -8.80414 -2.51529 14.0236 +3283 4 25.3563 19.2311 8.7609 -6.6335 -0.338001 12.1858 +3284 4 24.3761 19.0911 10.1338 17.243 1.91927 -22.7003 +3285 6 10.9743 8.21046 0.042398 -18.7759 13.8117 62.0104 +3286 4 10.3469 8.74796 0.639501 28.6352 -16.9877 -21.8389 +3287 4 11.7753 8.08291 0.592641 -4.28958 7.52309 -10.9298 +3288 6 15.7499 31.9609 31.3743 -17.6212 -20.5964 15.467 +3289 4 14.8817 31.9157 30.9761 -10.6343 5.00824 -7.09118 +3290 4 16.0827 32.8403 31.1978 10.1106 0.369155 -2.88897 +3291 6 20.3726 39.1695 21.6147 20.5981 -29.5513 41.0934 +3292 4 19.9726 38.3531 21.9994 -5.82675 23.323 -22.8284 +3293 4 21.1172 39.24 22.2595 -11.0324 14.4144 -20.0969 +3294 6 38.8594 19.5251 7.6091 -6.47304 13.0289 -25.1371 +3295 4 38.0017 19.0955 7.57416 -1.20877 -0.517864 1.64758 +3296 4 39.1744 19.3685 8.48411 8.18586 -10.9486 17.219 +3297 6 41.3695 29.7301 21.1465 -57.7285 -14.4296 34.1578 +3298 4 41.7832 29.6286 20.3251 24.9116 3.74799 -36.1007 +3299 4 41.9865 29.9579 21.8177 26.2541 9.18996 12.3917 +3300 6 50.7039 33.8333 22.0593 7.50244 -20.9835 17.6314 +3301 4 50.9654 32.9474 22.4123 -1.20949 24.7473 -8.4765 +3302 4 50.362 33.6446 21.1779 1.66119 1.27804 -3.63001 +3303 6 18.1671 11.1714 14.3658 -12.4278 -6.78987 13.7569 +3304 4 18.0724 11.2679 15.338 -0.312443 2.59996 -20.4321 +3305 4 19.115 11.0923 14.227 4.83391 -0.924272 -3.79066 +3306 6 48.5058 14.2689 15.2513 -36.7782 -21.7282 -18.3567 +3307 4 49.3677 14.5693 15.4148 44.1026 10.3807 8.68918 +3308 4 48.5803 13.5893 14.5426 -8.44167 10.5166 12.8885 +3309 6 32.9801 15.74 8.25484 19.5805 1.81858 6.30948 +3310 4 33.8151 15.5666 7.78828 -7.72407 0.576521 2.61047 +3311 4 33.2057 15.7253 9.21147 -5.47651 1.26655 -15.0149 +3312 6 42.9141 4.85593 18.7596 35.6338 16.8786 18.3104 +3313 4 43.0674 5.82698 18.891 -14.0493 -22.2454 -3.89051 +3314 4 43.7794 4.50634 19.0974 -23.5505 0.71427 -17.3058 +3315 6 10.488 23.7131 33.4436 27.6073 45.1219 -14.7699 +3316 4 10.638 24.6985 33.3892 -15.3766 -28.1208 6.63949 +3317 4 11.1638 23.4099 32.8243 -6.46894 -14.1785 5.09081 +3318 6 1.12582 20.0662 11.2775 2.81918 8.09367 56.8435 +3319 4 0.488344 19.3589 11.407 -2.14544 -6.99577 -20.9797 +3320 4 1.17571 20.424 12.22 2.69463 -2.11621 -44.733 +3321 6 1.50824 39.5346 14.3079 -5.25271 -28.0543 15.9462 +3322 4 0.868346 40.1487 14.6984 3.61457 -0.641003 -8.28938 +3323 4 1.2571 38.629 14.6571 12.5115 33.2201 -10.0417 +3324 6 8.3332 21.6069 14.1357 -16.8636 -16.8509 36.8071 +3325 4 8.17334 21.0976 14.9962 5.25323 23.3985 -29.627 +3326 4 7.56323 21.4407 13.5807 -3.95337 3.79773 -2.56685 +3327 6 7.16177 13.3249 38.2255 -6.34169 -18.8056 -1.32195 +3328 4 6.69256 13.0329 37.4043 9.76156 12.0715 20.3406 +3329 4 7.43529 14.2522 38.1581 -0.0118119 -11.8895 -14.491 +3330 6 46.6212 1.64167 18.6867 -0.0463537 -24.1078 41.7639 +3331 4 47.541 1.5611 18.992 -0.862753 9.16913 -10.8716 +3332 4 46.1606 1.36736 19.5239 4.43612 14.9978 -24.7224 +3333 6 4.08147 8.39338 14.788 26.1694 13.8207 2.32184 +3334 4 3.41636 8.28931 15.4347 -29.1417 0.0985708 23.0338 +3335 4 3.90156 7.69349 14.1818 -2.47935 -14.3959 -27.3016 +3336 6 47.5712 36.5372 17.8422 14.6219 44.3363 14.3039 +3337 4 47.1691 35.7037 17.6938 -6.70251 -40.3849 -9.96305 +3338 4 48.5299 36.4434 17.8412 5.708 -14.7801 -1.83759 +3339 6 48.7177 32.6293 3.61477 24.5557 -7.82504 -30.2396 +3340 4 49.3183 32.0587 3.09719 0.221751 18.4164 7.83871 +3341 4 48.4066 32.0299 4.25286 -21.3126 -17.4552 36.5328 +3342 6 26.8672 34.4113 15.184 7.18591 -12.831 -4.85448 +3343 4 27.1806 33.7337 15.7866 -5.2278 -3.11582 5.08403 +3344 4 27.3382 34.1395 14.3734 -5.71629 20.1707 6.74573 +3345 6 9.99603 27.3398 13.3337 -11.5184 -70.0362 -20.4383 +3346 4 9.96963 28.1856 12.9595 -3.0362 48.3298 -16.8459 +3347 4 9.789 26.7159 12.5598 12.8825 26.2078 29.4693 +3348 6 2.39106 26.8936 37.3456 -18.0299 -5.48602 7.48259 +3349 4 2.24944 26.7597 38.2955 12.6258 0.126767 -1.18485 +3350 4 3.33209 26.9598 37.1993 18.2818 -0.192027 1.55797 +3351 6 33.3384 17.273 36.7956 -4.69576 6.00605 30.6641 +3352 4 32.3777 17.4022 36.9421 6.35755 -1.66054 -12.3647 +3353 4 33.5147 17.1107 35.8745 -6.55426 -0.461729 -19.8283 +3354 6 10.6704 18.7989 9.29568 -2.62714 4.796 -4.28658 +3355 4 10.7729 18.8103 8.31395 -3.57004 -0.312677 18.1362 +3356 4 10.9356 19.679 9.6198 -4.15772 -1.10699 -11.1079 +3357 6 8.58029 27.4085 3.13543 -0.646896 -38.9365 14.7517 +3358 4 8.62134 27.4642 4.10772 -2.35878 18.0768 -8.00568 +3359 4 8.54298 26.4189 3.06204 -3.80038 30.3142 -4.62402 +3360 6 40.6121 33.9148 14.3433 -13.4775 28.2536 -12.7531 +3361 4 40.8898 33.2957 14.9932 8.13038 -23.145 12.8628 +3362 4 40.1237 34.5547 14.8716 -1.64981 1.12342 -7.13376 +3363 6 54.0126 16.7742 13.6402 -25.2384 12.1291 10.4483 +3364 4 54.0311 17.2666 12.8352 12.7766 5.78776 -30.0788 +3365 4 53.1083 16.9555 13.9311 3.38038 0.740926 17.4694 +3366 6 39.1613 38.4947 7.40674 -49.2832 -1.36929 38.9537 +3367 4 38.8094 38.4839 6.52049 1.87105 5.40513 -14.0728 +3368 4 38.3203 38.5292 7.99504 41.7155 2.10662 -28.5328 +3369 6 42.2152 33.6749 29.0207 -49.4578 14.7313 -27.4402 +3370 4 42.0113 34.6279 28.8262 15.7605 -21.0767 3.4048 +3371 4 41.3749 33.2313 28.6743 34.021 9.03137 24.2205 +3372 6 2.84529 0.06018 20.1342 1.75144 -0.125494 -5.27144 +3373 4 2.85876 0.453048 19.2323 -10.3946 -7.40064 8.89792 +3374 4 1.95714 41.5787 20.3005 13.5701 9.63706 -6.70109 +3375 6 24.9846 26.9367 24.435 4.97654 17.1262 30.4362 +3376 4 25.3707 26.0628 24.5275 -2.48626 -13.7157 -10.817 +3377 4 25.1946 27.3852 25.2847 -1.69157 -3.92554 -20.3381 +3378 6 13.6202 33.989 7.00835 -29.3159 10.7937 -13.6787 +3379 4 14.4707 33.6317 6.76766 5.19255 -3.31821 -12.8703 +3380 4 13.1262 34.2356 6.16936 24.7045 -4.21039 25.9053 +3381 6 17.6361 31.8361 3.38698 11.6752 63.8731 -26.646 +3382 4 17.3765 32.06 2.46015 3.81419 -8.12146 27.658 +3383 4 17.5414 30.922 3.45915 -17.4061 -53.1647 5.72422 +3384 6 31.114 29.8463 35.9142 20.4735 12.0385 -23.871 +3385 4 30.4046 29.6578 36.4892 -25.9224 -10.1565 23.4082 +3386 4 31.8798 29.3863 36.2596 4.49336 -0.641295 3.24883 +3387 6 31.4544 1.69927 1.93203 61.0942 61.1307 23.4408 +3388 4 30.847 1.03155 1.81447 -56.5376 -48.8621 -2.33617 +3389 4 31.1234 2.33851 2.60628 -4.67927 -17.7811 -18.4359 +3390 6 13.7206 9.35179 12.308 -20.4886 -14.5553 22.3614 +3391 4 13.8994 10.2254 12.0406 16.2488 33.284 -13.5816 +3392 4 13.1923 9.47724 13.1212 6.47756 -14.062 -7.29461 +3393 6 15.2915 15.1706 12.1407 -39.3514 -20.6771 -15.8676 +3394 4 14.288 15.1355 12.0691 34.6095 3.19954 13.2467 +3395 4 15.5721 14.5705 11.433 2.70369 1.94224 0.817449 +3396 6 44.9298 30.4448 13.0945 -83.0621 -13.8007 20.4391 +3397 4 45.2326 30.6692 13.9612 22.7288 5.76966 14.7184 +3398 4 45.5619 30.4921 12.4362 58.1466 4.79773 -38.6719 +3399 6 35.1494 37.6283 24.8564 -28.9971 -18.9514 34.2227 +3400 4 34.5453 38.351 25.1691 15.7809 -12.2194 -9.31628 +3401 4 34.8969 36.8477 25.46 15.2444 28.3361 -22.0595 +3402 6 43.9018 19.2999 12.9893 -4.23684 -28.8047 14.7243 +3403 4 43.7111 18.3276 12.9437 8.07938 21.0179 -2.3859 +3404 4 44.434 19.3703 13.8064 -8.2748 4.27416 -6.23054 +3405 6 14.1928 27.3824 16.8974 17.9721 24.801 -15.5057 +3406 4 13.3941 26.8971 17.049 -12.9837 -13.2841 -1.45311 +3407 4 14.075 27.8458 16.0392 0.928992 -14.2323 10.6565 +3408 6 5.07867 37.4759 15.7278 -19.2695 5.34987 61.0101 +3409 4 5.83402 37.4907 16.3496 5.41141 -1.20808 -8.02024 +3410 4 5.40595 37.3511 14.8725 27.2981 -13.142 -45.6678 +3411 6 35.4792 36.9736 33.2279 -33.1303 3.22524 14.2013 +3412 4 36.4062 37.0387 33.1707 43.394 6.70104 -6.41693 +3413 4 35.2647 37.5361 33.9926 -10.1497 -5.08286 -5.32556 +3414 6 6.63713 31.7122 32.9951 -15.6769 -13.4095 -29.903 +3415 4 7.30356 31.0631 32.7808 0.413821 -11.0386 -1.85208 +3416 4 7.01801 32.1732 33.7097 9.96672 21.2943 24.541 +3417 6 31.2686 20.2272 25.4717 1.63607 -11.2998 14.888 +3418 4 30.457 20.1188 26.0175 18.7046 8.55246 -6.40474 +3419 4 30.9671 20.3507 24.5747 -9.02709 8.2981 -6.80006 +3420 6 54.9594 26.0897 7.3541 -26.2324 -3.52234 4.1817 +3421 4 54.3149 26.536 6.76189 8.45344 -4.14623 9.81761 +3422 4 54.4064 25.6921 8.06559 9.60693 6.10548 -13.0393 +3423 6 17.8786 35.1581 24.3912 -48.4608 -31.2574 -23.2844 +3424 4 17.9034 34.576 25.1672 15.4891 12.513 -1.90366 +3425 4 17.14 34.695 23.8716 34.0055 23.8611 10.1154 +3426 6 49.1404 3.30993 19.753 -11.7437 -5.45724 -22.9314 +3427 4 48.7379 4.07245 20.162 -0.785462 12.6857 6.5087 +3428 4 49.8408 3.03849 20.3377 4.84054 -6.57183 8.59361 +3429 6 30.2791 35.6014 13.4902 -0.275976 1.62471 9.45881 +3430 4 29.4038 35.7322 13.1068 5.01216 -3.78726 -8.18413 +3431 4 30.1007 35.4484 14.4302 1.26073 -0.50544 -4.60872 +3432 6 43.3857 25.8788 41.6729 -28.3599 -13.2186 -4.43344 +3433 4 44.0236 25.6058 41.0289 13.0372 -2.28568 -15.7328 +3434 4 43.8192 26.4334 0.378509 18.4346 21.3926 23.5205 +3435 6 21.1033 23.1572 6.40534 -12.8895 6.60285 13.2505 +3436 4 21.2833 23.9599 6.94372 3.68538 -20.4677 -7.26612 +3437 4 21.2354 23.4378 5.50624 8.61756 6.39287 -19.4039 +3438 6 54.6209 21.1977 19.0953 -9.4905 16.5472 15.3455 +3439 4 0.355231 21.543 19.6762 -10.082 -5.94448 -19.8865 +3440 4 53.803 21.6498 19.4211 22.178 -8.62035 -3.94206 +3441 6 13.8696 38.9444 18.7589 -0.408574 -9.95072 10.686 +3442 4 13.5473 38.5195 19.5701 -4.79749 -3.34053 -10.6661 +3443 4 14.2783 39.7511 19.0654 -4.68159 17.5572 -2.41189 +3444 6 39.1837 2.73799 39.6933 -2.22487 -14.248 -19.2211 +3445 4 38.5048 2.18054 40.1045 3.50502 9.25929 9.72195 +3446 4 39.1752 2.3966 38.7788 -3.09486 7.3066 6.14055 +3447 6 43.2236 33.8218 8.83748 -23.7799 54.6507 -8.87946 +3448 4 43.1776 32.9835 9.22653 -2.14792 -45.6212 21.4927 +3449 4 42.4318 34.327 9.18683 27.5752 -12.6709 -4.85681 +3450 6 23.0768 16.6786 12.1043 19.2201 -8.5648 -22.0864 +3451 4 23.4688 16.2415 11.3109 -7.42341 7.06352 19.0042 +3452 4 22.1329 16.714 11.9048 -3.02708 6.60369 6.72608 +3453 6 40.7875 26.1445 36.3165 -31.0446 26.1707 15.63 +3454 4 40.1182 26.8831 36.2336 22.2291 -27.8038 4.66075 +3455 4 41.0346 25.9172 35.4285 12.0382 -0.567557 -16.236 +3456 6 15.1503 11.6728 19.298 -10.8743 -20.3409 15.6657 +3457 4 15.4707 12.2619 18.6272 13.0208 17.9076 -10.0848 +3458 4 15.518 11.9699 20.1418 -0.780585 5.28883 -4.88637 +3459 6 9.8485 29.8084 31.3808 31.6725 31.0987 -15.032 +3460 4 10.6075 30.172 31.8684 -9.75043 -12.6573 12.7307 +3461 4 9.98584 30.2945 30.5336 -20.1344 -22.7331 8.89086 +3462 6 2.12557 30.0341 25.264 -3.96851 -24.8252 -11.595 +3463 4 2.04755 29.1979 25.7442 2.8488 12.5065 4.07713 +3464 4 2.06741 29.7398 24.3306 5.27272 21.1251 20.17 +3465 6 49.0124 10.6515 7.04668 12.8278 -6.79775 19.6819 +3466 4 49.7765 10.456 7.62014 -4.12072 9.88663 -9.32692 +3467 4 48.4954 9.84699 7.16976 -12.5497 -3.43755 -7.74842 +3468 6 38.6385 34.4247 32.4851 8.7415 15.3068 2.26745 +3469 4 38.2449 35.2411 32.8392 7.79483 -2.42751 -9.0272 +3470 4 38.3877 33.7513 33.1114 -5.41613 -8.85245 5.88093 +3471 6 24.2967 24.7175 4.7858 -13.8074 20.2372 -8.25903 +3472 4 24.5879 23.8747 5.12331 8.49271 -10.4438 10.0312 +3473 4 24.0688 25.3355 5.52385 7.10746 -21.4288 -14.6014 +3474 6 44.0211 23.587 33.7713 -18.8641 -18.6234 -6.9532 +3475 4 43.6265 23.0569 33.047 -3.30007 6.44469 22.3225 +3476 4 44.7839 23.9213 33.3479 32.8249 22.1868 -7.88886 +3477 6 45.135 31.9539 26.6318 17.8742 -16.5206 -32.2352 +3478 4 44.6965 32.0125 27.458 -12.8805 4.46476 28.7394 +3479 4 45.0195 31.023 26.337 -1.34861 17.8758 10.4404 +3480 6 52.0545 6.36303 22.865 -1.87051 -30.929 -4.90791 +3481 4 51.4549 5.58836 23.0553 13.7734 29.2588 0.606927 +3482 4 51.4955 7.14596 22.8951 -3.5837 -3.73437 -5.39564 +3483 6 5.1124 17.7016 30.4663 -17.3022 -2.39818 -4.94531 +3484 4 5.57517 17.705 29.6436 5.33167 -14.42 -26.4334 +3485 4 5.6774 18.2653 30.9495 12.7188 16.8745 32.2475 +3486 6 48.5399 17.0091 6.52669 31.3107 25.6813 -22.3666 +3487 4 48.2466 16.108 6.56632 -4.44525 -18.5722 0.0807757 +3488 4 49.3123 17.0767 5.87973 -32.0368 -4.22047 21.2267 +3489 6 13.8017 31.3286 23.4652 -45.3568 -0.340859 23.461 +3490 4 14.0246 31.2001 24.3905 13.6426 -1.74144 -0.768444 +3491 4 14.5269 31.1963 22.8948 44.8358 -8.96568 -14.3918 +3492 6 28.4984 33.4231 26.025 30.2115 45.129 -4.70205 +3493 4 28.7629 32.7421 25.4284 0.749934 -18.6264 -12.7861 +3494 4 27.7356 33.1626 26.4825 -33.9251 -20.2776 22.3239 +3495 6 9.04101 22.9533 11.0101 4.17271 5.63899 8.67886 +3496 4 9.24243 22.776 10.0879 9.05926 -1.29962 -0.957415 +3497 4 9.84172 22.774 11.5341 -6.79246 0.647577 -9.3095 +3498 6 40.5624 4.0706 26.5792 43.7479 -58.1273 15.512 +3499 4 40.0377 4.03321 27.356 -14.6911 0.39925 31.4188 +3500 4 40.1771 4.74143 26.1095 -33.6389 57.2603 -43.6855 +3501 6 17.0606 37.9689 20.9328 24.9068 -2.83666 19.2437 +3502 4 17.7492 37.7057 21.5806 -0.23423 0.332892 -22.3637 +3503 4 16.3 37.9671 21.4825 -28.3901 -0.1668 6.57955 +3504 6 31.9758 6.36253 14.1925 -47.1359 -2.961 8.2158 +3505 4 31.6652 5.47044 14.4516 -0.57512 5.53961 -9.89258 +3506 4 32.9075 6.27907 14.242 33.1863 -3.34593 -3.73058 +3507 6 29.3613 34.9484 39.6522 -7.7658 6.78361 -10.4711 +3508 4 29.4154 34.7255 40.5688 2.48129 -3.65799 19.6008 +3509 4 28.4079 35.1232 39.5563 9.75382 -5.50564 -9.65046 +3510 6 22.5642 2.93231 32.1024 7.89654 -13.571 4.24933 +3511 4 23.152 3.60479 31.7467 -0.797152 8.5773 -0.128413 +3512 4 22.8746 2.10235 31.6905 -8.86372 14.3523 0.842504 +3513 6 51.7365 19.0888 24.8036 24.4352 10.6631 34.2631 +3514 4 52.2011 19.3182 25.6664 -22.8444 -5.9403 -33.5217 +3515 4 52.2256 19.5376 24.1035 -3.13425 5.18677 -1.50107 +3516 6 32.1309 13.661 24.2221 8.32979 -1.22201 -48.3483 +3517 4 32.1718 13.7834 25.1379 3.34806 7.10631 53.6256 +3518 4 31.2192 13.5434 23.9915 -25.9097 -1.66347 2.1781 +3519 6 9.49478 30.1756 28.7975 -1.02802 7.68553 8.51386 +3520 4 8.9614 29.4447 28.4635 3.13242 -3.87437 -3.11369 +3521 4 9.76139 30.7024 28.0341 -4.99689 -6.39164 -2.13333 +3522 6 31.3017 3.1328 24.0821 -2.56057 -13.3126 7.41322 +3523 4 30.8642 3.97896 23.9468 1.03353 -0.10231 -3.56587 +3524 4 32.1597 3.13825 23.6386 1.18226 10.803 -0.447916 +3525 6 2.13915 19.8328 36.4477 43.9795 26.8161 3.66972 +3526 4 3.0929 19.9274 36.115 -41.9598 -16.8793 8.64164 +3527 4 1.76662 18.9777 36.2517 -5.24508 -9.86619 -11.2286 +3528 6 36.9558 16.7701 14.0992 8.10199 -24.1685 -1.60142 +3529 4 37.0878 17.1202 14.9938 -3.44507 3.84646 -3.58016 +3530 4 37.3137 15.854 14.1066 -5.27996 15.1268 -1.92478 +3531 6 1.82451 11.1811 6.08431 4.75441 9.84221 -14.5701 +3532 4 1.68522 10.3449 6.52934 -2.64515 -5.74712 4.44833 +3533 4 1.45572 11.848 6.66197 -6.16769 2.71123 7.45582 +3534 6 43.1467 36.8536 25.2684 -4.34259 -25.2275 5.76074 +3535 4 42.489 36.6679 24.5813 -1.65581 9.08703 8.09798 +3536 4 42.9757 36.1566 25.9418 7.67001 18.3814 -10.5814 +3537 6 32.1358 5.54258 7.00813 -0.159667 5.03525 -3.02009 +3538 4 31.8447 4.70695 7.37259 1.76357 -8.94122 3.22744 +3539 4 31.6184 6.21523 7.45425 -7.92944 5.35442 3.67752 +3540 6 15.0738 21.498 41.5176 2.48253 -6.99424 4.64434 +3541 4 14.4083 21.441 0.286083 -5.89506 -4.91034 13.0846 +3542 4 14.6326 22.02 40.8608 1.523 7.8898 -22.5967 +3543 6 37.0299 36.0573 5.68999 -1.26402 -4.33671 -4.68257 +3544 4 36.8992 36.8706 5.1864 -9.04185 9.38437 4.54051 +3545 4 36.6368 36.1345 6.57983 4.68584 5.64444 -6.17041 +3546 6 39.6378 22.8733 0.344261 -10.4835 1.90991 -1.04201 +3547 4 39.8967 23.7127 41.8596 6.32696 2.65577 1.7872 +3548 4 39.7641 22.9598 1.30287 2.84221 -4.68177 2.22816 +3549 6 18.471 23.1695 5.24444 18.17 13.8994 5.32385 +3550 4 18.2426 24.0888 5.07969 -12.1406 8.45165 -11.681 +3551 4 19.3434 23.2774 5.65727 -5.17221 -14.3673 2.51868 +3552 6 34.4951 26.4012 0.415196 -24.2262 -21.8504 23.5375 +3553 4 33.9567 27.1096 0.873351 15.2264 -25.8266 -5.88921 +3554 4 34.3584 25.5285 0.919462 6.17703 40.7497 -12.3351 +3555 6 28.1538 26.089 40.6186 -44.0465 -12.7539 23.8091 +3556 4 29.0676 25.9468 40.8623 9.74545 0.451611 8.45277 +3557 4 27.5517 25.6856 41.3354 31.2048 15.0133 -28.9196 +3558 6 41.7541 4.40312 30.2348 -21.1804 7.97019 15.7848 +3559 4 42.5951 3.9554 30.1474 10.5948 -6.90465 6.49815 +3560 4 41.6197 4.66064 31.1807 9.39609 -4.15263 -13.0838 +3561 6 4.45746 8.30422 29.123 17.0584 8.0822 12.8675 +3562 4 3.72424 8.78851 28.7689 -20.5564 0.917363 -10.5697 +3563 4 4.90241 9.00738 29.631 2.39094 -12.8625 -4.67793 +3564 6 12.9051 9.61174 32.1485 9.54391 19.7002 1.20842 +3565 4 12.5238 8.90328 31.6499 -4.6135 -18.7028 0.941221 +3566 4 13.4507 9.29961 32.8815 -5.77341 -6.01915 -0.606497 +3567 6 48.6524 16.2364 1.45279 -39.5117 19.3379 22.5337 +3568 4 49.5656 16.3395 1.57323 44.82 -2.42546 -4.76282 +3569 4 48.322 16.6449 2.29127 -2.06599 -18.2277 -23.678 +3570 6 26.4391 39.9942 21.1964 -5.73 55.7886 4.05886 +3571 4 27.1886 40.6225 21.0926 -13.7426 -7.13397 8.25982 +3572 4 26.7825 39.1793 20.9147 12.833 -38.7313 -7.54244 +3573 6 35.8074 4.09236 9.03492 -45.4698 -15.3304 -15.5709 +3574 4 35.5046 4.67089 8.30824 2.24043 1.80806 6.22839 +3575 4 34.9768 3.81452 9.52186 26.5657 10.3238 -8.47709 +3576 6 52.6895 3.55751 27.8666 50.2867 -19.9176 -34.5196 +3577 4 53.5586 3.5996 28.3549 -33.5645 -3.53647 -1.9565 +3578 4 53.0019 3.22463 26.9489 -24.4009 21.759 36.9675 +3579 6 48.3192 26.6913 27.3954 13.1896 -37.7442 -6.45526 +3580 4 48.9722 25.929 27.4853 -22.116 34.446 0.770506 +3581 4 48.7243 27.4862 27.7371 6.43066 9.80699 11.7315 +3582 6 24.507 4.96042 18.7259 -17.59 -10.4057 14.9036 +3583 4 24.0519 4.20246 19.1729 14.2279 16.3534 -10.8515 +3584 4 23.9406 5.7442 18.8517 8.31711 -9.56192 -0.149656 +3585 6 24.0493 12.473 28.7688 20.4432 11.2466 2.34496 +3586 4 23.2439 12.9627 28.9427 -11.3477 -3.77152 -2.6943 +3587 4 23.8404 11.6087 28.4204 -6.74951 -3.90152 -5.01594 +3588 6 40.1637 27.7353 40.8087 -33.5791 -9.4694 0.953173 +3589 4 40.5641 26.9832 41.236 1.78301 2.25495 0.260865 +3590 4 39.2218 27.4214 40.7917 21.7476 20.7917 -9.34619 +3591 6 11.9335 13.5538 26.9488 -1.21599 4.57236 -11.9259 +3592 4 11.0364 13.8177 27.1576 -7.67129 -6.9102 2.53909 +3593 4 12.2164 12.9501 27.6309 4.70555 -13.4351 6.55277 +3594 6 52.1924 29.5424 41.3942 11.5626 -24.8936 -19.0003 +3595 4 51.8104 30.1965 0.050158 4.44506 23.3375 14.6186 +3596 4 53.1351 29.3771 41.6391 -10.5303 1.44862 4.74126 +3597 6 17.4882 19.0285 39.1853 -8.07927 32.7478 0.0743051 +3598 4 17.5012 19.6463 39.9647 -0.891206 -23.8414 -20.0908 +3599 4 17.261 19.5796 38.3923 8.05332 -16.519 21.1694 +3600 6 46.2326 27.6801 33.704 6.45393 -8.86534 7.23017 +3601 4 46.097 28.3723 33.048 -4.6559 5.79968 -1.93617 +3602 4 45.5979 27.7746 34.4233 -3.33861 16.4707 5.34235 +3603 6 35.8364 29.5448 5.62541 9.64171 -18.9009 -6.27826 +3604 4 35.5566 29.3199 4.72548 3.62776 14.0584 -3.56087 +3605 4 35.3944 30.354 5.86953 -6.57081 16.5188 2.47276 +3606 6 47.2881 25.7744 30.172 -6.62968 25.0044 -44.0548 +3607 4 48.1218 25.8653 29.6696 -5.94381 -7.49802 14.0131 +3608 4 46.6882 26.3745 29.6449 8.85802 -15.1094 17.4745 +3609 6 51.3842 12.359 20.0239 24.4626 17.3052 -5.31346 +3610 4 50.8707 12.833 19.3583 -10.0057 -7.98386 3.51527 +3611 4 50.8448 11.6564 20.3722 -11.0446 -8.70835 7.6307 +3612 6 41.976 18.3776 28.9581 25.2971 -7.26912 -18.3725 +3613 4 42.7018 17.9973 28.405 -17.3573 7.64094 3.96866 +3614 4 42.4517 18.9921 29.5246 -2.74764 -0.293653 0.793262 +3615 6 53.6043 6.48027 7.50524 -23.0657 -32.6432 -30.9738 +3616 4 53.1601 5.59498 7.33399 18.2827 28.6912 7.08019 +3617 4 53.6632 6.576 8.44633 9.6706 -3.87944 16.2616 +3618 6 9.90786 10.6094 26.7582 6.17728 8.73826 28.1859 +3619 4 10.299 10.3755 27.6331 -6.59671 -6.24018 -20.7073 +3620 4 9.65116 11.5299 26.9247 0.732239 -5.98194 -12.944 +3621 6 9.31054 39.3957 29.7756 40.7644 23.7808 19.8799 +3622 4 10.1982 39.3563 30.2561 -34.3316 0.809436 -14.8313 +3623 4 8.83679 40.1565 30.1832 5.55001 -15.1294 -12.8037 +3624 6 33.4099 4.77839 0.03236 -17.6047 -18.7695 14.8321 +3625 4 33.6454 5.53147 41.4176 15.8926 12.9618 -7.52592 +3626 4 34.0969 4.09847 41.8942 -0.186489 10.0102 -3.03658 +3627 6 35.7116 10.6673 34.2398 36.7653 -21.2814 -15.2586 +3628 4 35.2554 10.867 35.0388 -18.8422 0.575424 27.4634 +3629 4 36.4577 10.0619 34.4978 -21.6361 17.9445 -5.28322 +3630 6 15.2039 17.4016 19.1867 13.7018 -34.0248 -48.7675 +3631 4 15.5709 16.9982 18.3093 -23.7907 16.5473 43.0322 +3632 4 14.2523 17.472 19.021 -2.02403 4.48523 -0.714523 +3633 6 17.4757 37.6682 15.4227 -5.7624 0.927264 51.2416 +3634 4 17.0409 37.838 16.3209 3.67045 -5.85113 -35.7653 +3635 4 18.3529 37.3927 15.7202 1.879 4.38305 -13.464 +3636 6 26.263 8.20496 21.7043 -12.9193 13.0258 38.8746 +3637 4 26.2935 8.46487 22.6678 13.4631 -3.74504 -28.0146 +3638 4 25.3122 8.09558 21.5911 -4.90698 -1.77416 -12.6216 +3639 6 0.327844 9.89683 15.4174 -28.4002 -4.57955 -27.8061 +3640 4 1.20252 9.6859 15.1701 33.2298 -8.84956 3.25601 +3641 4 54.8213 9.3498 14.7471 -0.695723 21.8052 24.8209 +3642 6 13.451 40.6616 9.29616 -29.1589 -29.1317 3.11657 +3643 4 12.531 40.2581 9.2528 27.9164 27.237 1.6895 +3644 4 13.9533 39.998 9.7876 1.76749 3.89663 -1.50565 +3645 6 49.5605 25.9144 33.0102 6.77982 -23.7672 54.8124 +3646 4 50.0733 25.5846 33.8473 -25.1648 19.9091 -52.5505 +3647 4 48.6275 25.6453 33.15 14.5478 0.915879 -9.46863 +3648 6 37.0796 40.0419 26.4359 -26.9931 13.9721 12.3681 +3649 4 36.1882 39.5442 26.6099 42.8933 36.2545 -2.50818 +3650 4 37.051 41.026 26.6764 -12.8506 -44.3362 -9.04112 +3651 6 47.9916 17.8545 12.1553 -7.21137 29.6324 -37.7219 +3652 4 47.6652 18.6843 11.7058 6.42171 -29.0319 9.52509 +3653 4 47.7397 17.941 13.056 -8.12129 -2.80141 29.1943 +3654 6 27.9724 29.0571 34.165 6.45289 -21.5611 -2.40729 +3655 4 28.8948 28.8211 34.3683 -10.3018 1.8492 -2.91154 +3656 4 27.944 30.0064 34.1676 -0.713497 24.9251 0.854011 +3657 6 33.997 2.77014 13.2231 -35.3168 39.3397 6.14274 +3658 4 33.7592 2.40426 14.0871 -4.38792 -6.80294 -4.34532 +3659 4 34.7545 2.32608 12.931 40.4814 -27.3629 -5.76242 +3660 6 28.4454 36.033 11.4537 -30.811 -5.98685 22.1865 +3661 4 27.9997 35.3658 10.9161 0.521783 -1.73573 4.3727 +3662 4 28.9676 36.474 10.8303 31.7187 19.1344 -28.008 +3663 6 36.1836 11.3675 28.8638 -20.2526 -8.96451 -46.9053 +3664 4 35.201 11.3136 28.8426 17.393 5.15327 13.3727 +3665 4 36.3619 11.2493 27.8855 5.85658 3.26624 29.9739 +3666 6 24.7946 39.4802 16.9069 19.0937 3.96627 -8.4872 +3667 4 24.3751 40.345 16.9988 -5.97342 -3.52606 0.908874 +3668 4 24.9466 39.3518 15.9585 -10.9099 3.48913 2.54936 +3669 6 49.9504 8.05659 22.8451 -38.4139 -9.47108 -34.4931 +3670 4 49.9375 7.9588 23.7925 -16.1787 -3.75115 16.4902 +3671 4 49.0231 7.8493 22.4633 39.8101 3.17892 24.2331 +3672 6 52.1004 19.3469 10.2236 -1.12118 28.0811 1.24376 +3673 4 51.6057 19.3908 9.40186 -4.74475 -17.9853 -5.36861 +3674 4 52.3066 20.3081 10.2872 8.90847 -30.6944 7.30622 +3675 6 24.8344 15.8907 6.13046 -10.5287 3.62194 6.20212 +3676 4 24.2343 16.3288 6.78807 10.5214 -9.32926 -18.7028 +3677 4 24.4584 16.0701 5.24836 4.34413 4.47582 9.48796 +3678 6 49.3142 23.7074 8.6354 12.7826 -64.5552 32.8663 +3679 4 49.2168 22.9153 9.25307 13.1077 36.9849 -24.4484 +3680 4 48.4233 23.9587 8.46247 -20.5325 16.4959 -12.9251 +3681 6 0.200228 10.6387 32.1899 4.57462 9.08702 -50.3173 +3682 4 1.12405 10.3631 32.1441 4.84637 -6.06001 20.7538 +3683 4 54.8206 10.7585 33.0477 -1.25869 -8.0958 33.7963 +3684 6 12.5866 32.9145 13.2359 -45.84 -1.33101 12.3773 +3685 4 11.7384 33.4448 13.1799 26.1773 -16.8128 -1.90055 +3686 4 13.2757 33.4614 12.9111 20.4647 17.7705 -9.07485 +3687 6 21.729 32.5695 14.1172 -9.28791 -20.3928 5.37861 +3688 4 21.166 33.3661 14.1597 2.78901 -9.86158 3.94413 +3689 4 21.3002 31.8069 14.587 7.27427 31.5827 -10.8786 +3690 6 48.1522 34.8482 27.3304 1.15431 -17.6089 -40.5894 +3691 4 47.5385 35.1725 27.9994 -6.04073 -2.93057 -0.479876 +3692 4 47.6796 34.4132 26.5454 8.99615 21.2578 35.6726 +3693 6 45.6357 31.2393 36.095 -40.8957 20.4658 25.2026 +3694 4 45.8476 31.9489 35.493 1.2761 6.76392 -14.6383 +3695 4 44.8829 31.5945 36.6582 19.8537 -10.4851 -18.3708 +3696 6 46.2846 0.316369 14.3569 -23.6541 -29.5796 11.0344 +3697 4 46.2347 1.24867 14.1822 6.12226 14.592 -0.646978 +3698 4 47.172 41.8876 14.3137 22.6277 5.76419 -11.0491 +3699 6 14.3437 18.9821 40.2104 -25.2995 -33.3041 -15.9392 +3700 4 14.4094 19.2869 39.3238 4.54227 2.45102 -23.4893 +3701 4 14.593 19.7098 40.7196 18.3341 34.8836 33.2243 +3702 6 14.5595 1.13832 10.2184 21.0915 11.237 11.4523 +3703 4 15.4791 1.15983 9.85648 -24.9846 -0.242798 0.374642 +3704 4 14.0639 0.416501 9.81608 3.47586 -8.24251 -5.69878 +3705 6 34.4238 40.9137 13.0059 -4.24882 -26.6665 -25.0696 +3706 4 34.0907 40.4301 12.2099 6.6876 25.2293 12.1693 +3707 4 34.3655 40.2093 13.6737 -1.45879 20.9599 -0.365544 +3708 6 42.1372 25.6317 33.9946 32.9644 -29.1434 -4.32848 +3709 4 41.7256 25.3671 33.1599 -4.34041 1.82357 5.58197 +3710 4 42.8775 24.9612 34.1276 -26.6125 21.4128 -4.76888 +3711 6 29.2041 22.5904 40.0709 -12.2401 -3.24737 -11.2113 +3712 4 28.5312 23.0545 39.5673 2.40343 6.95864 -1.48823 +3713 4 29.0042 22.7646 40.9807 1.44808 0.219743 17.343 +3714 6 44.8039 18.6198 1.5029 3.83338 16.5679 14.3409 +3715 4 44.9659 19.0204 2.39019 -3.90529 -17.866 -14.3425 +3716 4 44.0478 19.1074 1.16429 2.25905 3.06151 -3.31671 +3717 6 4.48486 10.8191 23.9456 -47.6019 -35.9978 3.19751 +3718 4 5.13394 11.3869 23.6113 33.8353 31.137 -11.4748 +3719 4 4.52769 10.7271 24.8961 2.68899 9.9192 5.78369 +3720 6 6.46393 23.0191 29.0034 23.802 4.69353 23.6764 +3721 4 7.14249 23.0161 29.7285 -18.6834 17.7038 -21.9419 +3722 4 6.49076 22.0968 28.8008 -10.0115 -22.5628 -12.4771 +3723 6 39.7912 25.1434 32.5739 17.5205 -18.6836 -60.5647 +3724 4 39.6128 25.3468 33.4485 -16.6712 22.7672 53.7369 +3725 4 39.6667 25.9357 32.0325 -1.3786 -0.359445 4.68486 +3726 6 40.844 21.4875 8.87812 10.6958 -1.16061 -24.4784 +3727 4 40.753 21.3778 7.91779 -6.86728 3.07162 8.13114 +3728 4 41.3272 20.6946 9.13123 4.7165 -6.17308 11.2164 +3729 6 0.614957 1.42802 12.9561 35.282 30.4207 -35.1483 +3730 4 54.8795 1.90166 12.5287 -4.84596 -15.7095 11.3484 +3731 4 0.325279 0.716474 13.4972 -22.2917 -16.9379 18.816 +3732 6 32.6687 29.7155 23.4821 0.172893 -14.8348 21.3896 +3733 4 32.2937 28.8037 23.5347 8.27316 18.2339 -7.75927 +3734 4 32.5776 29.9928 22.5742 -5.86304 -0.191283 -15.879 +3735 6 12.5314 37.1515 20.4729 45.6241 64.5302 32.6184 +3736 4 13.0675 37.1561 21.3077 -14.1528 -0.638655 -18.1117 +3737 4 12.0966 36.3476 20.454 -27.4762 -63.6198 -6.10217 +3738 6 13.8924 14.5151 24.69 -3.15938 -4.02598 20.115 +3739 4 13.491 15.2498 24.2338 -4.44789 9.69439 -9.34194 +3740 4 14.0279 14.8194 25.6039 -0.281954 0.872924 -9.09093 +3741 6 17.5021 27.063 26.4741 18.9499 -7.93165 -17.7551 +3742 4 17.3645 27.9616 26.0981 5.20292 -20.1733 2.46217 +3743 4 18.105 26.551 25.8503 -19.0729 23.9469 15.4793 +3744 6 54.4877 9.53021 26.3477 -5.78247 7.96784 25.4661 +3745 4 54.0512 10.3733 26.628 8.34027 -15.1138 -9.49744 +3746 4 54.8923 9.139 27.1544 -8.60221 9.32804 -13.3813 +3747 6 33.6807 21.5011 24.9225 20.8165 12.7411 -37.5161 +3748 4 33.6447 21.5342 23.9109 -0.857654 -11.0597 35.2787 +3749 4 32.8481 21.1477 25.2212 -19.5227 -6.82771 5.56304 +3750 6 22.1475 35.2701 2.885 -1.57378 -2.18642 30.1771 +3751 4 22.1887 34.3602 2.5781 3.09514 -3.18559 -9.19859 +3752 4 22.1072 35.1817 3.87164 0.12039 0.813186 -18.6146 +3753 6 45.3027 5.41438 15.6133 24.4211 -32.124 17.7203 +3754 4 45.2073 5.06649 16.5292 -4.89018 16.6426 -14.7318 +3755 4 44.541 5.92364 15.3615 -17.3903 4.72304 -1.03383 +3756 6 5.67534 7.5869 16.981 -5.47297 6.8358 -20.2139 +3757 4 5.25896 7.81046 16.1225 6.35918 -0.232773 12.9215 +3758 4 6.51331 8.07041 16.9918 4.7107 -6.94883 2.60141 +3759 6 34.576 39.0992 27.2053 24.5889 13.5844 -33.9491 +3760 4 34.3093 38.4547 27.8221 -16.0328 -19.2876 29.327 +3761 4 34.0621 39.904 27.3046 -7.96056 4.01318 13.6593 +3762 6 32.7541 33.6107 34.2903 -12.2088 11.6467 -22.6039 +3763 4 32.1008 34.0277 33.6489 27.9813 -13.6615 23.3944 +3764 4 32.6574 34.0489 35.1447 -11.8345 -0.637226 -0.957772 +3765 6 31.0088 41.2052 32.3952 -16.5884 -4.13679 -5.08533 +3766 4 30.2065 41.1942 32.9317 -1.71273 -1.00977 6.80252 +3767 4 30.9738 0.147898 31.9828 5.47722 15.337 -6.15299 +3768 6 7.65161 1.58314 27.1492 34.9115 -9.04616 -23.8477 +3769 4 8.49581 1.43905 26.61 -35.9655 -7.00487 18.1392 +3770 4 7.51162 2.51613 27.0476 -4.48076 16.5289 1.77021 +3771 6 0.884173 22.0999 37.8474 19.5684 -22.3581 -15.9684 +3772 4 1.29289 21.3236 37.3582 -15.3878 24.821 16.8607 +3773 4 1.19208 22.8872 37.3739 -1.97361 -3.14502 -0.467946 +3774 6 7.41204 11.1157 19.2314 -38.1481 -15.0427 -1.85178 +3775 4 7.53858 12.0593 19.2468 12.5581 17.6457 8.19935 +3776 4 8.2604 10.6916 19.3015 17.9889 5.14781 -4.65775 +3777 6 43.7858 12.4956 37.3097 0.920036 9.73958 -3.1733 +3778 4 43.9612 12.5094 36.3537 -0.436236 -2.21513 6.60981 +3779 4 44.6264 12.7918 37.692 -0.443403 -7.75914 -0.361508 +3780 6 29.0868 33.5248 36.1867 6.33086 18.8505 -43.8567 +3781 4 29.87 33.99 35.8176 -18.9328 -5.41066 10.4629 +3782 4 29.4633 33.0358 36.8874 15.3521 -14.5291 31.9885 +3783 6 14.802 4.59099 3.93345 20.4849 22.8827 12.2406 +3784 4 14.3757 4.0439 3.27797 -5.14737 -6.71868 -8.73832 +3785 4 15.6594 4.91612 3.57855 -16.4986 -14.1515 -5.85747 +3786 6 39.0551 6.39795 6.38864 -31.6963 1.09254 42.8867 +3787 4 39.3692 7.21691 6.04781 17.6944 18.3081 -17.2196 +3788 4 39.3538 5.69048 5.84285 10.6785 -8.50098 -20.4551 +3789 6 22.2123 37.9977 40.776 -14.7699 -23.2033 -28.4168 +3790 4 22.4586 38.8695 40.5021 9.68098 25.7962 -2.3277 +3791 4 22.4791 37.9118 41.6765 7.85923 -2.07179 26.9545 +3792 6 4.44877 23.2867 6.14309 -1.92846 -21.7963 14.7751 +3793 4 3.85981 23.8785 6.59389 -8.34079 22.3777 -5.30491 +3794 4 4.15148 22.4458 6.53602 18.5324 -1.87236 -10.5169 +3795 6 12.4298 23.7885 9.24819 15.5635 1.24594 19.7483 +3796 4 11.6299 23.5219 8.81427 -22.2296 0.449899 -3.14002 +3797 4 12.2156 24.1823 10.1208 2.55292 -1.37139 -18.7826 +3798 6 46.4922 15.2589 16.9667 3.22745 3.94864 2.0367 +3799 4 47.1791 14.9867 16.3488 -1.59454 -10.7105 -10.6804 +3800 4 46.8221 16.1143 17.2497 1.89409 2.98219 12.0057 +3801 6 34.1117 27.1644 19.7797 24.4736 -11.2812 21.2279 +3802 4 34.8774 26.5238 19.7962 -19.6491 14.1094 -6.20677 +3803 4 34.0324 27.4806 20.6991 -2.21978 -4.312 -16.0235 +3804 6 46.9479 13.2121 35.1109 14.7829 18.0264 15.8687 +3805 4 47.3232 14.0654 34.8894 8.1348 3.75559 6.81177 +3806 4 46.5576 12.9943 34.2929 -17.7211 -19.0679 -23.646 +3807 6 50.5883 18.7922 12.536 -4.97475 -8.40096 -18.6689 +3808 4 49.7377 18.4417 12.2063 9.85466 0.19572 8.20723 +3809 4 51.2037 18.6585 11.7837 -7.44169 10.1395 9.07394 +3810 6 32.4871 12.6357 31.9554 3.75694 -28.5712 -45.9238 +3811 4 32.607 11.6542 31.8864 5.47128 21.8321 9.55763 +3812 4 32.4011 12.8494 32.8587 -4.02679 2.16968 41.7104 +3813 6 6.20502 19.6778 10.0162 1.71901 21.9334 16.0314 +3814 4 6.41826 20.2441 9.25697 6.75258 -1.0862 1.44387 +3815 4 6.08129 20.3112 10.7738 2.93045 -16.0896 -19.0741 +3816 6 21.5254 21.5246 2.44441 10.1652 3.23891 -24.6245 +3817 4 21.7373 21.5014 1.49425 -3.90993 5.22039 4.49463 +3818 4 22.0841 20.8004 2.76184 -10.1442 1.98878 12.5692 +3819 6 38.3901 23.0895 17.1987 11.9637 -29.1373 -23.0023 +3820 4 38.7115 23.1739 16.2902 2.30233 23.4463 5.8212 +3821 4 38.6091 22.1461 17.2941 -10.4226 8.48715 23.8901 +3822 6 29.6992 24.9636 22.2212 38.6917 -37.4999 -9.7813 +3823 4 30.2244 25.0209 22.9989 19.9484 -5.9881 25.7874 +3824 4 29.0295 25.5321 22.4534 -63.588 46.0104 6.14599 +3825 6 30.2959 21.4331 37.7732 -36.6703 24.7369 -1.55525 +3826 4 30.3833 21.3736 36.7928 -5.6984 1.01251 23.2154 +3827 4 29.3642 21.7906 38.031 44.833 -25.8334 -23.6526 +3828 6 11.8968 11.712 16.3062 -52.2626 -16.509 -42.1992 +3829 4 11.3487 12.2512 16.8737 -4.04714 4.99791 6.8918 +3830 4 11.2749 11.5458 15.4981 35.5887 6.11969 38.645 +3831 6 5.69762 16.9728 10.4703 1.06122 -0.586779 5.28994 +3832 4 4.99177 17.1708 11.0979 -1.96678 -11.04 -5.71485 +3833 4 5.85288 17.8179 10.0528 3.40155 4.97172 -3.96907 +3834 6 41.7052 34.1635 35.8846 2.77529 22.9845 38.2917 +3835 4 41.9958 35.0267 36.2582 -8.6238 -19.1969 -5.00662 +3836 4 41.6615 34.3005 34.9574 -2.57818 -0.630621 -34.674 +3837 6 33.7668 1.16041 30.1021 -7.73366 -5.3538 60.0773 +3838 4 32.8437 1.27671 30.3431 -6.56672 10.3256 -18.6068 +3839 4 34.0939 1.04339 31.0463 15.1522 -1.22783 -40.312 +3840 6 50.3589 18.6227 36.9888 29.2523 22.0538 -2.88024 +3841 4 50.1022 18.8636 37.8788 -6.7252 3.81489 7.59342 +3842 4 49.7597 17.9698 36.6907 -30.5426 -29.286 -11.4073 +3843 6 24.6818 24.2557 40.239 -30.3362 18.6852 9.52233 +3844 4 23.7683 24.4347 40.5809 21.1328 -2.57181 -5.50386 +3845 4 24.791 23.3075 40.3447 2.5826 -1.14956 -5.51696 +3846 6 37.3025 22.0306 23.2304 -1.24857 -1.55203 26.5345 +3847 4 37.0034 21.8174 24.1364 -3.77965 7.42086 -11.5868 +3848 4 37.7677 21.2337 22.9852 8.84969 -1.31238 -13.2672 +3849 6 48.4163 40.4951 28.9695 -6.68628 11.813 -16.9736 +3850 4 49.0084 41.2243 28.7075 -10.6266 -4.31108 -6.63999 +3851 4 47.6767 40.479 28.3098 12.2088 -0.876211 11.6705 +3852 6 24.8524 8.74511 16.566 -5.47802 -1.24744 16.6444 +3853 4 25.3154 9.32041 17.1898 2.58295 -0.80606 -7.28092 +3854 4 25.3735 7.93816 16.4942 1.51819 -5.71343 -7.74972 +3855 6 19.2312 23.0154 32.4581 7.29767 -10.2486 -2.08042 +3856 4 18.4295 23.4489 32.1618 3.75321 4.57429 -6.83594 +3857 4 18.9208 22.4103 33.1253 1.01223 -4.21105 8.69504 +3858 6 3.33807 21.6805 22.4551 -46.3933 -7.60477 16.0737 +3859 4 2.65604 22.1286 23.0335 23.3212 -20.9163 -13.0515 +3860 4 4.02869 22.318 22.3903 27.1551 13.0827 -5.07429 +3861 6 10.2258 20.3371 12.829 -8.54969 -20.6717 -8.68144 +3862 4 9.56384 20.8338 13.3253 4.28314 2.73019 -3.94148 +3863 4 9.70568 19.6401 12.367 8.3544 15.6282 9.01344 +3864 6 9.53393 0.668964 25.3385 8.23748 17.1946 -9.08311 +3865 4 10.3992 0.538209 25.8183 -20.1327 16.9559 -17.4439 +3866 4 9.57635 1.38514 24.6117 12.9812 -33.3008 29.4344 +3867 6 10.6624 40.712 9.64369 -16.6479 -8.09828 -30.6343 +3868 4 10.6692 41.3905 10.303 1.51816 10.4523 18.0663 +3869 4 9.97599 41.0031 8.99599 12.0328 -9.66263 16.6565 +3870 6 46.359 25.2248 32.6769 -14.7838 37.2607 37.796 +3871 4 46.1367 26.0735 33.2154 13.6855 -48.6436 -31.9122 +3872 4 46.6282 25.5659 31.8216 4.36769 -3.83668 -6.22015 +3873 6 38.9431 3.2028 23.1016 18.0409 -17.6687 24.963 +3874 4 38.0396 3.32435 22.9005 -28.138 13.963 -19.732 +3875 4 38.8834 2.64883 23.9052 13.1186 5.8311 -6.82495 +3876 6 33.334 23.6417 36.8871 -1.6197 -14.346 14.9842 +3877 4 32.7695 23.6175 37.7211 18.6046 10.6207 -30.6843 +3878 4 33.5528 24.5621 36.6745 -4.59115 1.63353 1.59233 +3879 6 51.9355 33.3272 25.435 24.4931 61.1901 -39.0042 +3880 4 51.4286 33.1494 26.1943 -20.5556 -13.8295 37.3068 +3881 4 51.9313 34.3506 25.3627 -2.33157 -52.0679 -5.38276 +3882 6 32.1777 25.0215 33.1655 -4.40266 21.2191 -9.05445 +3883 4 32.7541 25.8194 33.0841 -10.7751 -17.7804 3.95932 +3884 4 31.2703 25.3891 33.0319 13.5135 -10.8842 0.697404 +3885 6 51.2858 27.7149 39.5023 -29.438 -28.7732 26.1015 +3886 4 51.6029 27.7352 38.6212 16.0201 9.86215 -30.6452 +3887 4 51.6337 28.456 39.976 12.6328 17.4546 7.30145 +3888 6 34.2938 28.319 17.2582 8.1769 -6.30709 4.0332 +3889 4 33.5147 28.7567 16.9609 -27.2201 13.5182 -7.119 +3890 4 34.2215 28.3851 18.2119 5.48963 -10.3892 10.8325 +3891 6 36.9125 8.03614 37.8626 31.6258 41.6511 37.5008 +3892 4 37.1772 8.64874 37.1722 -6.23292 -16.4311 -22.0997 +3893 4 37.3691 8.52088 38.6203 -30.9712 -36.3395 -15.9768 +3894 6 34.8794 19.4073 6.12479 12.5531 6.66298 1.29528 +3895 4 34.0931 18.8687 6.15723 -9.84615 -2.81902 0.903663 +3896 4 34.5874 20.3343 6.07707 7.75337 -1.04832 -3.72421 +3897 6 52.9388 9.46792 7.82791 49.0384 32.8563 -49.3294 +3898 4 52.8922 10.1625 7.06425 -6.6048 -31.3865 41.9454 +3899 4 52.145 9.34409 8.30569 -37.6802 7.72308 13.142 +3900 6 36.3078 5.4787 38.9756 -59.3492 -35.3574 -23.3076 +3901 4 36.7604 5.44249 39.7856 34.2456 7.44664 27.0781 +3902 4 36.4713 6.28646 38.5283 19.3627 32.146 -13.2298 +3903 6 10.0102 14.4476 13.47 7.45507 32.9986 11.9551 +3904 4 10.2267 15.3574 13.7991 -6.33005 -21.0964 -5.42394 +3905 4 9.26267 14.5991 12.8847 -7.70629 -5.78085 -0.713961 +3906 6 17.2158 24.3617 39.7859 1.82925 -26.4802 17.5225 +3907 4 16.9252 25.2477 39.6578 -10.2532 23.1813 -8.78866 +3908 4 16.8659 24.1409 40.6742 12.3143 -2.49802 -8.33055 +3909 6 49.0708 32.5605 7.76617 4.98775 -19.9892 12.4117 +3910 4 48.2488 33.0406 7.85919 -4.66971 4.38963 1.84033 +3911 4 49.5854 32.9586 7.08254 9.03816 10.9607 -18.1455 +3912 6 44.8772 24.3958 5.47001 55.4245 15.4507 -4.26518 +3913 4 44.8128 24.5742 6.41303 -16.1158 -0.171295 7.10823 +3914 4 44.0866 23.9971 5.17679 -42.0653 -18.1716 -4.3799 +3915 6 37.3106 29.1913 32.8596 13.2918 -7.82588 25.4298 +3916 4 36.7195 29.353 33.61 10.148 2.43022 -0.346483 +3917 4 36.7915 29.3572 32.1043 -27.5405 3.64351 -29.7293 +3918 6 0.903259 24.8209 21.2384 21.1637 23.8586 -12.5999 +3919 4 1.07153 25.1845 20.3306 -6.36458 -4.90686 24.2304 +3920 4 1.48599 25.3539 21.839 -15.2813 -16.355 -7.82064 +3921 6 53.0335 2.20305 13.0061 -8.76459 0.917863 -30.1717 +3922 4 52.7178 1.83592 13.8181 -1.16689 -4.66991 20.3458 +3923 4 53.3973 3.07458 13.1779 4.70755 1.41814 13.7418 +3924 6 24.3073 33.9788 13.9425 26.9643 -19.8352 3.53447 +3925 4 23.8166 33.1535 14.1304 2.48225 11.7572 -2.64876 +3926 4 25.2622 33.8278 14.204 -36.1259 9.29052 -3.07765 +3927 6 40.931 19.3008 0.314297 -22.2267 40.7784 4.53314 +3928 4 41.073 18.3876 0.266006 15.5735 -49.6404 -1.39225 +3929 4 41.7685 19.7545 0.415523 11.1161 2.19254 -0.550631 +3930 6 38.3131 32.0321 21.5909 -11.558 27.6654 -12.3629 +3931 4 37.7152 31.3901 21.181 3.54948 -0.803384 -4.61225 +3932 4 38.0485 32.9451 21.2634 6.02672 -33.9485 15.0266 +3933 6 42.3093 34.9988 16.9782 -31.0886 21.3467 -4.04435 +3934 4 41.4322 34.9872 17.4259 23.1708 5.16072 -1.2535 +3935 4 42.7209 34.172 17.1456 10.0707 -23.8474 2.85212 +3936 6 19.5555 24.3301 21.9337 4.81064 -45.312 41.7565 +3937 4 19.0503 23.5208 22.2695 18.6897 32.4519 -16.5084 +3938 4 18.9494 24.7901 21.383 -21.2783 9.24005 -16.3011 +3939 6 21.0765 3.08453 14.9497 18.8565 6.62045 0.482113 +3940 4 21.9827 3.42458 15.1377 -20.4059 -2.71097 -2.70114 +3941 4 21.0593 2.94323 13.9894 -7.00518 -5.35814 1.95693 +3942 6 16.4422 12.1477 28.531 -0.750899 4.00912 3.87665 +3943 4 16.9503 12.6102 29.2147 -1.62139 -0.392447 -5.94721 +3944 4 15.8278 12.7952 28.1633 1.40376 -4.03425 1.22377 +3945 6 29.5501 4.7113 21.752 31.6763 -19.7408 -11.7502 +3946 4 29.7575 3.81476 21.3864 -8.62397 20.1371 9.94028 +3947 4 28.6767 4.97136 21.4837 -14.307 1.15287 -5.34284 +3948 6 47.4015 12.0887 13.4082 -20.234 -20.0739 19.2385 +3949 4 46.7896 12.1748 12.658 5.24956 2.33261 8.08179 +3950 4 46.8763 11.6307 14.143 25.8489 23.9178 -32.3489 +3951 6 26.4368 0.034911 5.58657 -64.7941 -10.5287 17.818 +3952 4 25.4579 0.386547 5.64311 57.7785 -5.53424 -8.5606 +3953 4 26.2825 41.0177 5.90114 11.1228 18.2746 -10.9356 +3954 6 20.8239 34.8091 41.3451 3.02448 22.7042 23.7072 +3955 4 20.8848 35.7307 41.7064 -1.83719 -23.2001 -12.5561 +3956 4 21.5135 34.3024 41.8142 -0.435548 5.34794 -5.15218 +3957 6 12.6914 17.4806 1.38079 -1.22179 11.8948 19.0955 +3958 4 12.6924 17.2614 2.32235 1.20892 0.120609 -3.36771 +3959 4 12.6119 16.652 0.923905 -0.609755 -13.5185 -16.0456 +3960 6 30.0783 10.198 8.41195 2.12134 -1.25171 -25.3141 +3961 4 29.3533 10.7626 8.0964 5.01977 -3.23694 0.534487 +3962 4 29.9182 10.0601 9.33268 -3.94599 -2.47727 24.1034 +3963 6 36.3506 5.44781 23.9083 -0.549638 14.3818 20.7021 +3964 4 36.0156 6.32048 23.6328 6.62881 -2.58855 0.476976 +3965 4 37.0027 5.63115 24.6267 -8.58297 -8.41851 -13.9364 +3966 6 34.0301 39.9488 19.4964 -23.0399 -20.8249 18.5921 +3967 4 34.456 39.4415 20.2152 6.93565 15.6495 -14.2212 +3968 4 34.6348 40.5483 19.0534 11.5364 2.12704 2.14354 +3969 6 25.0981 29.0133 17.0022 63.4673 53.603 -24.6749 +3970 4 24.4066 28.4545 17.2066 -49.3728 -47.1307 14.2315 +3971 4 24.9323 29.3693 16.11 -4.01222 -10.2038 10.3173 +3972 6 28.4991 21.3215 6.5284 30.3134 51.3135 12.4116 +3973 4 28.073 21.8131 5.82363 -12.0684 -17.0718 -17.6117 +3974 4 29.0439 22.0969 6.88435 -18.1485 -38.7813 5.23359 +3975 6 18.6639 26.1486 0.434559 17.278 41.4043 -10.2832 +3976 4 18.2934 25.3073 0.618971 -26.4426 -25.2614 5.85754 +3977 4 18.1648 26.8598 0.892557 2.28699 -17.4047 3.2853 +3978 6 10.9881 29.7025 15.4563 -76.0882 18.6105 19.9394 +3979 4 11.66 29.3744 14.945 58.6215 -25.2203 -34.7363 +3980 4 11.3165 30.0451 16.2682 18.0847 5.23212 20.5617 +3981 6 33.4842 3.75768 10.5858 0.636803 10.5574 28.6939 +3982 4 33.4734 3.50079 11.5612 -0.522502 1.02567 -36.066 +3983 4 33.5593 4.73652 10.6 -0.068286 -14.4363 0.33475 +3984 6 12.2823 28.8038 23.0281 11.3775 -6.29424 6.84391 +3985 4 12.7596 29.6284 22.9364 3.04418 8.52871 -1.54448 +3986 4 11.6562 28.9633 23.7417 -11.9653 1.92572 -6.97409 +3987 6 13.0879 10.2853 41.0171 -47.2786 6.02767 7.69694 +3988 4 13.8008 10.0588 41.5617 38.8858 -12.6991 24.323 +3989 4 13.445 10.533 40.1929 12.5253 9.31307 -31.237 +3990 6 45.8279 29.9763 22.3517 -19.0059 -47.3471 -0.794771 +3991 4 46.3385 30.6632 22.7121 22.9496 35.5749 11.5915 +3992 4 46.1736 29.1608 22.8005 -10.4716 15.4455 -15.9284 +3993 6 41.5587 12.1258 14.79 16.8952 2.46742 -19.497 +3994 4 40.8127 12.0778 15.3866 -8.88903 2.06539 11.4921 +3995 4 41.9001 13.025 14.8368 0.886253 5.83282 4.44761 +3996 6 18.1774 7.21532 24.17 -10.7079 71.0597 15.5191 +3997 4 17.3895 7.85304 24.2309 32.278 -29.8877 -8.26822 +3998 4 17.8432 6.3671 24.0218 -31.5603 -50.1252 -1.23769 +3999 6 1.46617 28.3087 7.5822 17.4051 32.8243 -18.4272 +4000 4 0.972435 27.5241 7.77639 -23.983 -7.56132 -3.64975 +4001 4 0.919057 29.0368 7.16413 8.17263 -22.6878 11.3207 +4002 6 11.3257 12.3178 24.0505 6.50608 36.5044 21.7543 +4003 4 11.787 12.9182 24.6663 -15.142 9.53056 -9.69028 +4004 4 11.7144 11.5384 24.3755 9.90684 -45.3393 2.97811 +4005 6 17.9727 40.4585 24.4268 -2.1753 13.4943 43.6914 +4006 4 18.2079 40.9973 23.706 15.3173 17.1897 -35.5256 +4007 4 17.8423 41.1404 25.131 2.16294 -27.9915 -10.5346 +4008 6 25.5983 7.44259 34.0136 19.3716 5.77393 -21.6373 +4009 4 25.8935 7.97324 33.2232 -7.88236 -13.8451 20.6491 +4010 4 24.6626 7.5793 34.1612 -12.3217 5.75259 0.6842 +4011 6 16.9533 36.3934 7.79695 -14.7733 -58.972 -15.2131 +4012 4 16.1509 35.7821 7.92089 32.5681 38.8119 0.0631702 +4013 4 16.873 37.2333 8.21975 -10.866 19.0251 14.3825 +4014 6 12.4478 39.1676 36.8063 -58.2746 -19.2691 -7.14825 +4015 4 13.2621 39.5728 37.0444 24.763 -2.90148 -1.94315 +4016 4 12.5678 38.2718 36.42 14.2903 21.5885 11.3364 +4017 6 23.4428 1.91286 37.7232 -9.22102 6.32267 -24.8838 +4018 4 22.7837 1.60923 37.0782 3.11058 2.78987 13.6287 +4019 4 23.6923 2.7833 37.361 6.97145 -2.92816 9.87668 +4020 6 26.6131 34.8527 39.0629 -0.358317 22.46 -5.08852 +4021 4 25.9211 35.0251 39.7209 4.63868 -0.642547 -8.45736 +4022 4 26.6245 35.623 38.4346 -11.8568 -25.3624 13.8384 +4023 6 44.7506 35.5772 23.1679 10.7298 -18.8811 -26.4233 +4024 4 44.6498 36.2622 23.8111 -7.39072 22.4611 10.5052 +4025 4 44.899 35.9413 22.2637 -2.27133 -5.1907 16.9936 +4026 6 34.6136 35.4178 26.71 -15.9342 1.46423 13.2724 +4027 4 33.7739 35.201 27.1682 15.3038 9.13482 -13.5788 +4028 4 35.2424 35.4667 27.4557 -1.55634 5.60609 -12.3698 +4029 6 12.4253 29.8367 9.37257 6.8074 7.71813 14.8361 +4030 4 12.5954 30.1793 10.279 -1.64518 -2.79843 -17.3301 +4031 4 11.9756 30.5342 8.87466 -2.55144 0.413422 5.70549 +4032 6 46.4578 41.3781 16.9525 -1.71223 -15.9012 -6.63524 +4033 4 46.309 0.164546 17.5847 2.66821 13.6546 8.2853 +4034 4 46.3887 41.8168 16.0911 -0.805017 -2.71613 2.08401 +4035 6 39.1753 31.0467 24.0118 -3.10819 6.08124 -21.6124 +4036 4 39.1065 31.2708 23.0301 -7.23524 -5.82233 36.9271 +4037 4 38.2867 31.0608 24.4123 9.52041 3.88051 -10.8568 +4038 6 40.5402 9.7597 28.9847 14.8037 -28.2595 -25.194 +4039 4 40.7176 8.78836 28.9335 -4.00485 22.4893 3.39032 +4040 4 39.9733 9.89103 29.7293 -9.65138 5.58475 19.0645 +4041 6 33.5593 11.9211 22.729 -1.15717 -3.69298 36.7387 +4042 4 33.4631 12.1387 21.8005 -14.8881 8.7456 -3.74916 +4043 4 32.9393 12.4796 23.2922 26.8098 -15.4098 -27.756 +4044 6 29.0159 38.7519 2.46278 27.6721 -15.5988 -40.3681 +4045 4 29.1586 39.6546 2.1748 2.74048 3.67355 2.54153 +4046 4 28.5501 38.8453 3.26351 -22.211 -0.421087 25.3577 +4047 6 51.2833 6.14739 28.3043 6.24107 -1.78447 -16.8419 +4048 4 51.6927 5.30788 28.0231 -4.79213 3.01935 13.8596 +4049 4 51.5671 6.73798 27.5888 -1.89698 -2.53529 10.4249 +4050 6 34.1064 16.6123 14.042 -37.0155 -16.4066 -7.07731 +4051 4 33.9904 17.5439 13.9588 -10.6946 23.5239 -0.125603 +4052 4 35.0244 16.4872 14.0391 48.662 -2.86898 -0.118382 +4053 6 34.4321 40.0645 7.48859 13.9518 5.57425 38.6209 +4054 4 34.6497 40.8416 6.93548 -15.3832 -25.9537 -5.407 +4055 4 34.0868 39.3056 7.01264 2.49953 7.17747 -18.8692 +4056 6 42.5297 22.9808 4.38266 2.56422 12.7755 -29.8183 +4057 4 42.7079 23.1404 3.43503 2.07895 -8.20356 9.72626 +4058 4 41.6007 23.2438 4.43282 3.68115 -1.88729 13.9368 +4059 6 1.41725 11.7089 10.583 40.9585 72.4956 7.82458 +4060 4 2.29602 11.7947 10.1149 -31.3121 -19.1762 2.07637 +4061 4 1.32217 12.6809 10.8959 0.250133 -47.8987 -12.0904 +4062 6 10.0222 17.1523 40.4009 -13.9984 -42.4532 23.0969 +4063 4 9.09922 16.7881 40.4362 25.3227 17.9847 -3.64852 +4064 4 10.5566 16.4623 40.9043 -11.7978 28.1532 -20.1855 +4065 6 26.3773 1.16785 23.7951 0.897687 17.1036 -20.4546 +4066 4 26.2949 1.59753 22.8926 6.72339 -10.2637 31.134 +4067 4 26.8106 1.83522 24.3632 0.404944 -5.36666 -8.232 +4068 6 4.47728 16.2319 39.0174 38.9165 -19.7518 -18.3291 +4069 4 4.60126 15.8787 38.0926 -3.95383 11.2541 23.7603 +4070 4 5.37849 16.1152 39.4714 -36.6531 9.54225 -13.0705 +4071 6 24.3645 39.8454 14.0862 11.6717 18.512 -7.42816 +4072 4 24.2179 40.7168 13.6655 -1.51261 -13.0973 5.973 +4073 4 25.144 39.5095 13.6466 2.38152 -7.3908 -1.6645 +4074 6 19.9724 19.004 10.1294 8.87966 -14.5095 2.71373 +4075 4 19.0999 19.3915 10.2782 -1.93643 -3.06257 7.63815 +4076 4 20.1403 18.2899 10.8137 -9.49435 28.7308 -18.8504 +4077 6 45.2455 15.0555 25.2985 9.44949 25.5865 29.6023 +4078 4 44.5225 15.6147 25.6238 -9.11717 -2.3226 -13.4673 +4079 4 44.9162 14.4027 24.6993 -17.0358 -18.2103 -14.0354 +4080 6 47.6513 32.9537 29.9733 -3.02769 -8.48031 15.1317 +4081 4 47.7848 32.4488 30.7976 5.01558 10.2706 -8.76515 +4082 4 46.6987 33.0693 29.9097 -5.02316 -0.316015 -4.02449 +4083 6 9.31033 14.1561 35.6305 -9.15199 13.4931 14.7277 +4084 4 10.2186 13.9515 35.3646 1.69372 -1.68405 10.862 +4085 4 9.25805 14.5533 36.5394 11.2175 -11.577 -22.5615 +4086 6 0.560208 28.7354 32.128 -23.2584 38.0618 20.8665 +4087 4 0.439761 29.1616 31.2639 2.79308 -8.58991 0.800302 +4088 4 0.67028 27.8063 31.9961 10.5465 -16.7679 -9.91325 +4089 6 26.1282 14.1993 40.8411 59.6454 -38.6249 5.43898 +4090 4 26.432 13.4524 41.4491 -20.3805 31.5142 -12.0858 +4091 4 25.201 14.2926 40.8644 -35.6636 2.31432 7.08225 +4092 6 38.0409 1.72795 37.3461 -15.986 9.3487 3.27435 +4093 4 38.337 1.77003 36.4219 -6.4212 0.733726 8.60438 +4094 4 37.1869 2.24333 37.3721 25.3175 -16.9011 -0.126137 +4095 6 43.391 21.0055 0.385428 11.1435 51.3868 10.1231 +4096 4 43.3728 21.9356 0.739051 -22.7765 -27.5137 5.23027 +4097 4 44.2566 21.1078 41.893 4.66373 -25.0138 -11.6612 +4098 6 29.7339 12.3948 17.084 15.7249 11.0657 13.1734 +4099 4 30.3928 12.9555 17.5239 -4.04604 16.1495 -27.1654 +4100 4 29.6387 11.801 17.8166 -19.321 -23.8097 4.84602 +4101 6 21.0831 10.9976 35.6454 20.8751 25.9078 26.8503 +4102 4 20.9144 11.9356 35.5 -2.5465 -0.914036 2.40284 +4103 4 20.6111 10.5739 34.9651 -17.7649 -25.2648 -31.6786 +4104 6 24.3635 22.1336 17.0651 -49.7832 5.03398 -16.9936 +4105 4 24.7447 22.8357 16.5516 14.0354 11.6369 -2.31656 +4106 4 25.0369 21.6158 17.4366 35.7007 -17.2122 18.4164 +4107 6 44.2543 9.63808 6.15039 20.313 -11.2139 14.5913 +4108 4 44.7688 9.46356 5.36091 -1.47318 -0.699349 -10.0319 +4109 4 43.371 9.9028 5.92157 -14.9065 6.10764 -5.2575 +4110 6 40.8032 2.87739 6.28666 -13.1289 22.479 10.901 +4111 4 40.3272 3.11809 7.09229 2.74106 -9.45257 -1.64817 +4112 4 40.5645 3.60702 5.69531 8.12536 -6.41414 -12.3146 +4113 6 23.4888 29.7691 25.1996 -20.8577 -7.3866 7.78845 +4114 4 23.0356 30.0691 24.4173 -11.1707 -5.96106 -7.76576 +4115 4 24.1981 30.3761 25.2406 38.2449 14.7306 0.541559 +4116 6 45.2336 20.6129 7.48752 -14.5833 -17.9538 -3.88696 +4117 4 44.4222 20.5961 6.94177 10.1673 3.83834 -0.615812 +4118 4 45.4226 19.6724 7.65027 4.1577 11.2609 0.378107 +4119 6 44.1804 26.5848 16.646 -7.77871 8.0927 60.0057 +4120 4 44.4497 26.5291 15.7549 9.82788 -17.3929 -39.3829 +4121 4 43.995 25.6977 17.0036 0.668911 -2.30329 -14.751 +4122 6 23.5902 27.0659 18.0913 -39.7013 -11.93 7.95298 +4123 4 23.083 26.2674 17.8176 19.208 11.4009 -9.44785 +4124 4 22.9184 27.4761 18.6801 25.6051 0.00742342 -8.40738 +4125 6 45.1467 16.0991 8.91755 -25.3782 -1.90264 -8.59791 +4126 4 44.1891 15.9425 8.7462 16.1978 6.4454 1.17339 +4127 4 45.2138 16.0078 9.87006 7.52298 -2.6657 10.2407 +4128 6 39.0203 15.1531 5.23259 28.6956 12.0263 -26.8074 +4129 4 39.7994 15.5772 4.7964 -10.087 -12.1112 6.39319 +4130 4 38.3368 15.7917 5.08662 -19.5574 10.6606 0.980846 +4131 6 40.468 4.77411 20.0927 -27.3359 -4.798 12.1592 +4132 4 41.2634 4.72652 19.6 29.6653 -1.38796 -18.2664 +4133 4 40.7147 5.23292 20.8909 -0.487482 4.30709 11.6637 +4134 6 35.8395 28.4372 39.9091 -50.8572 -25.335 -8.14583 +4135 4 35.0416 27.8127 39.7761 37.8149 25.8469 12.2999 +4136 4 36.4241 28.1912 39.1903 12.774 -11.5781 0.139918 +4137 6 26.5706 3.57143 2.67715 -46.9093 11.529 -12.2012 +4138 4 26.01 3.47498 1.86726 21.0232 -0.263485 19.1529 +4139 4 25.9795 4.13239 3.25499 25.5536 -16.3527 -3.3314 +4140 6 2.96374 21.6426 17.6806 -14.2306 -5.51577 -4.68338 +4141 4 2.93927 22.2072 18.4518 0.989431 6.72084 9.51867 +4142 4 3.70489 21.9005 17.1296 5.59779 10.8847 0.849605 +4143 6 12.8869 25.0552 25.9401 15.4127 26.4598 -14.83 +4144 4 13.2774 25.9118 25.6194 -5.06291 -21.1213 8.866 +4145 4 12.0842 24.9634 25.4247 -11.7493 -3.09829 -2.0396 +4146 6 41.5869 20.6707 14.1801 -22.4147 -6.05744 0.611169 +4147 4 42.2929 20.1295 13.8255 12.8925 2.43785 -7.39699 +4148 4 41.9118 21.5622 14.3536 8.70683 -8.7017 2.36606 +4149 6 1.26372 39.5934 11.5416 -2.31472 -23.2994 -17.666 +4150 4 1.60499 38.7626 11.0579 -12.721 36.8399 30.164 +4151 4 1.30151 39.4907 12.5143 8.15813 -4.07121 -11.1907 +4152 6 16.0274 39.0089 34.0759 -23.376 3.35378 -54.2756 +4153 4 15.5279 38.2654 33.6809 12.2329 5.59336 21.1278 +4154 4 15.9645 39.6681 33.3256 8.94624 -4.65522 31.8649 +4155 6 20.5749 7.01511 25.5545 -9.93748 22.9073 -1.77669 +4156 4 20.7998 7.9126 25.2373 7.69672 -13.5438 0.480138 +4157 4 19.6147 7.02086 25.4453 1.79337 -5.45304 -5.32881 +4158 6 45.1903 25.5946 39.1745 -26.3826 2.10768 23.1727 +4159 4 45.9078 26.0337 38.7511 23.0136 15.7961 -19.2282 +4160 4 45.315 24.6755 38.9972 4.74877 -22.0383 -3.82349 +4161 6 19.9254 40.1108 28.2935 0.936604 13.13 -6.83142 +4162 4 19.0415 40.3022 27.9603 -1.00367 -13.9734 -0.221352 +4163 4 20.1058 40.9072 28.8104 6.81084 -8.28794 7.10232 +4164 6 26.5025 14.2024 27.3816 7.55525 -11.5245 -39.7478 +4165 4 25.5661 14.1885 27.2241 -23.3405 -0.187867 -1.3667 +4166 4 26.5864 14.6167 28.2174 4.05242 7.69107 36.9512 +4167 6 51.349 25.9455 3.44193 13.1564 1.83251 -14.1309 +4168 4 51.0731 25.276 4.04973 -8.84751 -13.2679 15.0063 +4169 4 51.8098 25.4164 2.75525 -2.9574 19.5765 2.79729 +4170 6 20.1579 26.1269 2.66057 8.08543 -14.232 12.5138 +4171 4 20.4198 25.2285 2.95049 1.99012 13.1431 -7.88687 +4172 4 19.9848 26.1042 1.70984 -1.68704 0.137755 2.48294 +4173 6 3.12857 11.9594 27.2244 18.8731 20.7243 14.7894 +4174 4 2.60719 12.6622 26.8077 5.30838 -2.59233 -3.81502 +4175 4 3.76928 12.4285 27.8301 -19.9135 -11.7573 -12.7739 +4176 6 30.1745 26.3671 4.00755 44.117 -33.7612 35.926 +4177 4 30.7719 25.91 3.40695 8.20711 -11.5121 5.52432 +4178 4 29.6741 26.8182 3.4039 -49.0538 48.0497 -39.0484 +4179 6 19.309 20.6617 30.5327 -6.17305 20.3286 19.7257 +4180 4 19.3357 21.5037 31.0044 -16.2324 -1.53368 2.5841 +4181 4 20.215 20.6027 30.2783 24.1248 -10.9268 -16.9107 +4182 6 13.5428 36.2605 0.333332 15.0011 -10.6689 28.2547 +4183 4 13.9636 37.1467 0.274336 -13.564 -9.3403 -16.0521 +4184 4 12.8146 36.0991 41.6409 -4.77188 14.7057 -15.3617 +4185 6 13.69 21.7667 35.9665 -20.2473 -15.4187 -13.4538 +4186 4 13.4364 21.3658 35.099 7.7487 10.4825 13.8843 +4187 4 14.5406 22.1631 35.8296 17.4857 6.37333 -3.13554 +4188 6 39.4374 1.76506 25.3393 -36.4427 -7.29022 -10.5984 +4189 4 39.9364 2.34528 25.9215 16.7605 -3.08023 1.72977 +4190 4 39.8192 0.8892 25.1573 19.013 15.1682 11.727 +4191 6 18.3049 6.14326 35.8392 -10.8025 -19.5812 3.54688 +4192 4 18.125 5.32611 36.3393 4.50778 0.182671 -16.8727 +4193 4 18.2664 6.78418 36.55 10.3297 13.4079 -7.40032 +4194 6 2.50698 24.635 10.1008 2.82606 57.1639 14.1456 +4195 4 3.34783 24.2504 10.0645 38.9609 -42.7111 -6.9151 +4196 4 2.85647 25.509 10.4424 -34.1939 -15.4438 -5.60802 +4197 6 35.8245 9.94707 1.36321 12.392 22.5458 6.51215 +4198 4 36.2598 10.3662 0.602857 -1.03193 -1.33218 7.37913 +4199 4 36.14 10.4815 2.15194 -8.91958 -29.9524 -28.0328 +4200 6 29.0093 17.9332 41.5934 -7.9582 -11.0366 0.585828 +4201 4 28.5465 17.2289 41.1281 -16.7755 -3.81322 9.83818 +4202 4 29.6221 18.1453 40.9114 24.9254 25.1746 -10.164 +4203 6 46.0106 27.0842 25.8657 -15.8538 -10.6571 1.20957 +4204 4 46.7573 26.8966 26.4316 13.3887 1.52966 8.34957 +4205 4 45.3967 26.3449 26.0537 1.02353 6.85943 -7.5889 +4206 6 28.1115 10.6516 35.9124 -31.4415 -9.81676 -35.067 +4207 4 27.3321 11.0804 35.4953 10.9044 -14.8673 0.927998 +4208 4 28.4149 11.3158 36.4913 19.5717 24.3857 28.0975 +4209 6 25.9462 20.1874 24.7713 21.0981 19.7274 8.06252 +4210 4 26.7479 20.7296 24.6265 -12.3387 -9.71047 -3.27099 +4211 4 25.8934 20.1715 25.7373 -11.4252 -1.9185 3.65337 +4212 6 32.2315 30.2636 10.2038 46.2181 -42.2335 3.06511 +4213 4 32.6954 30.7903 9.55855 -13.4496 21.2522 -10.6663 +4214 4 32.9512 29.5744 10.3289 -28.7668 14.232 9.31608 +4215 6 5.05112 34.4033 23.8133 19.5013 -14.7597 17.0713 +4216 4 5.8904 34.9145 23.8209 -18.4686 -4.57798 -7.44977 +4217 4 4.4328 34.8283 23.2333 -4.78059 12.4432 -11.9709 +4218 6 29.6287 34.9421 23.1129 15.2461 20.4143 1.29823 +4219 4 30.2662 35.203 23.7945 -9.70178 1.77141 2.28452 +4220 4 29.7307 34.0083 23.0447 -4.13429 -24.1479 2.03513 +4221 6 52.1909 25.2296 36.2512 2.86438 -10.6824 22.6831 +4222 4 51.9483 25.3775 37.2028 5.23419 -4.07811 -26.4725 +4223 4 52.3343 24.2634 36.1804 -4.32722 6.81431 1.64545 +4224 6 6.96184 41.26 14.9825 2.80521 -5.8094 -40.534 +4225 4 7.04984 41.0874 15.8994 5.94782 -9.0625 22.8431 +4226 4 7.58542 40.6644 14.4953 -8.6815 16.2518 18.3581 +4227 6 27.6618 39.1341 4.65497 -15.321 -2.42325 19.5764 +4228 4 26.8583 38.6531 4.9607 13.8024 7.31782 -7.34321 +4229 4 28.2878 39.16 5.39008 -5.06496 -7.53921 2.22048 +4230 6 44.4448 15.8874 30.3939 -2.31018 0.103575 -22.4191 +4231 4 43.6353 16.4379 30.2788 15.6665 -12.4266 1.42045 +4232 4 44.7559 15.574 29.5018 -16.8402 11.4423 19.721 +4233 6 27.2939 38.1254 13.0955 15.3768 -40.6351 2.35664 +4234 4 27.6299 37.3572 12.5713 -6.06373 15.2601 5.99839 +4235 4 27.2975 37.7701 14.0147 -10.0522 11.5876 -10.9657 +4236 6 26.6773 32.9794 36.8294 -32.6396 -25.4624 12.1292 +4237 4 27.3491 33.5429 36.5103 30.2383 22.5556 -9.12925 +4238 4 26.1784 33.4868 37.4729 2.39424 7.35453 7.52648 +4239 6 26.3034 28.2003 31.7109 71.1077 16.3155 0.283388 +4240 4 26.8193 28.3341 30.863 -27.929 -6.55919 23.3278 +4241 4 26.9955 28.4613 32.4053 -35.143 -9.24619 -18.2719 +4242 6 49.2075 35.7729 23.3324 -21.4287 30.6035 9.89313 +4243 4 49.7648 36.3085 23.9054 5.92838 -6.84736 -0.0129328 +4244 4 49.7125 35.0813 22.9401 23.5965 -22.3057 -11.2126 +4245 6 44.2384 15.3735 33.5479 -0.546939 -12.4927 -0.897907 +4246 4 44.8734 15.133 32.8785 13.8917 -2.34347 -2.72297 +4247 4 43.5631 15.8174 33.0372 -7.79828 14.1806 -0.143619 +4248 6 16.6415 35.2629 14.0425 -13.711 -12.7272 -22.5016 +4249 4 16.8779 36.1297 14.3524 2.35153 17.3801 14.4176 +4250 4 15.7232 35.3535 13.695 18.4875 1.24889 7.88518 +4251 6 45.2979 21.4768 12.0753 -61.6802 -17.7786 9.36854 +4252 4 45.9745 21.1118 11.5746 47.2025 -15.5682 -31.9287 +4253 4 44.6407 20.7302 12.0307 13.4445 30.1014 15.4365 +4254 6 51.647 5.33893 20.0992 17.3373 6.85256 40.4731 +4255 4 51.8423 5.82757 20.9547 -12.0569 -16.4938 -26.4666 +4256 4 50.8652 5.75336 19.736 -8.70547 10.2387 -6.49138 +4257 6 22.616 27.3068 0.953729 -12.5585 5.72419 11.7926 +4258 4 21.9912 27.9206 1.39427 2.62886 -13.0847 -9.82719 +4259 4 22.9744 27.8285 0.229956 6.91293 3.08187 -2.36887 +4260 6 46.8924 12.1405 22.3241 28.0037 10.4006 6.07885 +4261 4 46.5361 12.6234 21.5839 -13.5229 3.11861 -11.9828 +4262 4 46.2058 11.655 22.757 -25.8682 -9.85748 8.02404 +4263 6 33.7577 5.61095 25.2306 8.81298 -10.6825 9.18366 +4264 4 34.4045 5.06092 24.7535 -5.77276 6.31779 -0.0821136 +4265 4 33.06 5.8369 24.6155 -4.37455 2.20678 -7.03208 +4266 6 44.2424 18.1337 27.2287 35.5912 4.17402 -1.61274 +4267 4 44.1428 18.6708 26.4104 -1.15401 -3.8952 20.8354 +4268 4 45.2041 18.2132 27.495 -32.4507 -0.562547 -10.2772 +4269 6 5.27745 36.9951 29.0779 -48.9341 45.2857 -18.2185 +4270 4 4.83797 37.847 28.7 19.7525 -41.2711 21.6555 +4271 4 6.18662 37.2124 29.1987 31.023 4.60304 7.81739 +4272 6 20.0415 5.02171 38.9415 13.5567 -45.1901 -20.6947 +4273 4 19.673 5.46942 39.6755 -5.65499 20.9205 26.8401 +4274 4 20.3443 4.13258 39.2728 -11.021 23.424 -4.53385 +4275 6 17.9077 2.77821 33.872 -28.7289 7.66476 22.1934 +4276 4 18.5675 3.36618 33.4993 11.2764 5.36232 -3.32863 +4277 4 17.289 3.30252 34.4687 25.3234 -20.0176 -17.8345 +4278 6 5.56252 23.3664 22.3199 23.4646 34.0494 22.6536 +4279 4 6.31266 23.4141 21.6995 -10.6272 -11.1368 -5.13028 +4280 4 5.83055 24.0852 22.9498 -18.4748 -15.0058 -11.9197 +4281 6 12.7366 28.0136 40.0786 16.9267 17.0007 -14.1953 +4282 4 12.7736 28.981 40.2539 2.04889 -13.1204 -10.7842 +4283 4 13.1752 27.8683 39.2015 -12.0592 5.90979 20.7524 +4284 6 50.5208 38.8121 28.4283 -2.96204 -29.3557 2.62021 +4285 4 51.1161 39.4306 28.008 -0.383593 20.3423 -2.32338 +4286 4 49.7133 39.2143 28.7877 7.69194 10.1621 -6.76025 +4287 6 33.551 8.21903 17.8634 -36.1599 -47.4859 45.2019 +4288 4 33.9333 8.85376 17.3385 32.2471 57.3944 -47.1321 +4289 4 33.8604 7.38657 17.5128 5.83122 -9.97324 -0.737685 +4290 6 34.648 34.7105 17.7828 9.01761 -19.7832 -8.77749 +4291 4 35.1788 35.3328 18.2888 -3.00831 8.66808 4.62333 +4292 4 35.2883 34.0014 17.5711 -12.5093 2.94991 -0.39307 +4293 6 40.7261 5.27864 23.3991 8.21105 0.19251 11.4926 +4294 4 41.4259 4.93717 23.9966 -11.2767 2.88733 -17.4667 +4295 4 40.0598 4.58084 23.2941 1.87831 5.06613 5.43463 +4296 6 16.9137 27.769 14.4809 73.6258 -34.7175 -8.82476 +4297 4 16.0667 28.1115 14.4612 -62.8462 32.6704 -2.60496 +4298 4 17.5486 28.5101 14.4313 -15.9271 -1.25076 7.8547 +4299 6 29.0219 14.6595 5.00786 20.8741 -13.5443 13.1138 +4300 4 29.536 13.8229 4.89138 -12.0375 16.0826 3.98067 +4301 4 28.8859 14.7576 5.97494 -2.91261 0.0620574 -16.4413 +4302 6 36.854 17.7325 5.08016 4.48522 -18.3735 -43.8449 +4303 4 36.2168 18.3553 5.39001 -11.7806 18.6728 17.0618 +4304 4 36.8305 17.8608 4.09391 11.7548 -5.76061 25.8999 +4305 6 27.7142 25.5094 34.8662 20.7401 -29.3529 -12.6468 +4306 4 28.3997 25.1535 35.4786 -13.7878 13.2187 -9.69645 +4307 4 27.3728 26.292 35.2699 -5.77421 14.8272 18.3022 +4308 6 24.7481 17.2805 18.0642 -3.31447 -10.4308 -2.46491 +4309 4 25.3087 17.9154 18.5049 2.27957 10.048 8.00722 +4310 4 24.0564 17.0505 18.7104 4.01172 4.3516 -6.8818 +4311 6 30.1789 1.58441 5.83411 4.12275 19.8646 -71.4749 +4312 4 29.4821 1.85802 6.42075 -6.9839 1.28517 8.89789 +4313 4 29.959 2.0434 4.91278 6.77151 -29.6581 61.3265 +4314 6 37.452 25.891 8.43789 -40.1641 -31.4732 50.6902 +4315 4 38.334 25.9927 8.78667 20.6785 -4.95116 -4.15592 +4316 4 36.9881 25.2791 9.14634 19.6253 32.8331 -49.0064 +4317 6 24.7604 7.00734 2.27008 32.0581 9.85747 -12.4546 +4318 4 25.4028 6.31463 2.48931 -5.40489 7.62931 7.6933 +4319 4 23.9158 6.58667 2.26874 -21.5893 -3.78057 4.11792 +4320 6 25.7887 38.8506 10.7619 -30.5475 28.1992 -59.3139 +4321 4 26.3103 38.4194 11.381 38.5207 -12.4255 48.7922 +4322 4 26.1525 39.7259 10.4932 -1.18865 -9.03037 15.3914 +4323 6 0.555207 13.578 28.1388 12.6332 42.7054 11.738 +4324 4 0.341766 12.7807 27.7179 -10.1825 -36.9478 -16.4943 +4325 4 0.413626 13.4435 29.0864 -5.17296 -1.28815 -2.85065 +4326 6 20.4105 17.1191 12.037 -17.9302 -38.4569 -26.5492 +4327 4 20.2295 17.2547 12.9605 -1.34068 5.07474 20.9983 +4328 4 19.8884 16.3005 11.7926 16.4515 20.0565 4.33162 +4329 6 30.9925 7.37797 16.6653 29.7996 22.3073 3.61878 +4330 4 31.2643 7.03844 15.7784 -2.63758 10.9944 17.123 +4331 4 31.7569 7.94595 17.0261 -27.6116 -29.8279 -14.8225 +4332 6 10.2093 5.78517 12.1714 32.5037 6.96704 58.397 +4333 4 10.1014 6.35617 11.4591 -8.08786 32.1119 -50.7901 +4334 4 9.65707 5.06197 12.024 -36.7963 -41.1043 -15.4671 +4335 6 18.4347 31.3493 24.155 3.48135 -6.25246 2.65688 +4336 4 18.4439 30.3878 24.2879 -2.95335 1.71216 0.944019 +4337 4 18.3198 31.7316 25.0273 -3.67252 2.09543 1.27238 +4338 6 27.8948 29.2525 29.2666 2.33504 21.8021 -21.5937 +4339 4 28.3627 29.5914 28.4251 -11.9103 -18.4763 37.4515 +4340 4 28.5196 28.9609 29.9463 14.9294 0.890267 -8.6061 +4341 6 38.3738 15.4456 29.791 12.9945 -28.6313 15.0543 +4342 4 38.0891 14.5036 30.0544 22.1369 39.5396 -7.74746 +4343 4 39.2957 15.632 30.1541 -37.4531 -3.97597 -10.3113 +4344 6 21.7041 34.7992 5.56934 -10.1436 -56.1371 25.2208 +4345 4 21.4621 33.8673 5.89439 16.7439 32.0975 -19.9868 +4346 4 20.9431 35.2741 5.907 -2.46203 13.3807 -4.97838 +4347 6 18.2064 16.8274 1.01093 1.02147 5.09087 9.91972 +4348 4 17.6405 17.264 0.353478 -0.489627 -6.58546 6.49815 +4349 4 17.8529 17.0628 1.89865 0.517006 0.361128 -13.8735 +4350 6 43.5166 18.4972 39.3436 16.5286 13.9247 -42.0759 +4351 4 43.0101 19.1966 39.7112 -21.9319 15.1254 24.622 +4352 4 43.7095 18.933 38.4597 1.00685 -29.3013 20.2287 +4353 6 17.7976 10.0688 35.5434 7.86102 19.599 -20.2005 +4354 4 17.8945 9.40709 36.2105 4.74187 -18.2058 11.3424 +4355 4 18.5459 9.97323 34.9151 -16.2901 -5.18221 9.2364 +4356 6 36.5889 30.5599 29.0828 -33.0481 48.6405 -12.465 +4357 4 36.5132 31.4977 28.7143 1.54088 -37.0728 8.50934 +4358 4 37.4982 30.324 28.9756 25.7485 -11.7594 -3.68806 +4359 6 38.4943 35.9682 10.4222 10.3079 16.2999 40.226 +4360 4 38.6552 36.6966 11.1228 -3.33458 -34.9071 -25.8136 +4361 4 38.3509 35.1294 10.9235 4.16648 17.1849 -3.98913 +4362 6 43.4036 18.8037 34.3607 -18.7725 -42.8138 41.3108 +4363 4 42.9709 18.1893 33.7432 11.3097 10.906 -2.86187 +4364 4 43.2777 18.3171 35.2411 6.94038 29.5352 -30.5758 +4365 6 11.0585 40.2128 6.10885 -15.7783 5.94868 1.16987 +4366 4 11.5965 40.9262 6.45194 10.3679 4.26541 4.32644 +4367 4 10.1443 40.5526 6.13585 6.40705 -5.05479 -5.29954 +4368 6 48.3342 13.7493 24.4707 -3.46168 30.4962 28.8754 +4369 4 47.8576 13.3588 23.754 -13.8134 -6.92474 -20.9085 +4370 4 47.8711 14.5963 24.7134 14.7345 -25.1065 -10.1999 +4371 6 1.47205 25.7712 23.7829 0.184952 23.7651 -2.41746 +4372 4 0.854396 26.4618 23.4919 -3.79407 -11.1699 -2.17794 +4373 4 2.13056 26.3319 24.2122 9.67536 -12.9921 7.11562 +4374 6 20.5856 0.045789 21.1048 4.96875 -22.7073 -7.43464 +4375 4 19.8117 0.249922 21.5931 -19.4423 21.7426 16.1957 +4376 4 20.4519 41.001 21.0443 13.8042 -0.350206 -3.82588 +4377 6 37.6675 12.896 30.7055 18.9575 -14.1068 -43.1025 +4378 4 37.1872 12.5493 29.907 3.14127 2.53034 24.3729 +4379 4 37.0391 13.1763 31.3358 -31.377 6.23238 20.3235 +4380 6 49.4665 17.3801 9.24655 -8.32961 25.946 -15.5009 +4381 4 48.5345 17.665 9.32633 16.3924 -11.5392 1.15372 +4382 4 49.8219 17.9883 8.54454 -1.98957 -21.6031 19.5257 +4383 6 34.3643 5.3502 17.1421 32.952 7.78829 -18.2658 +4384 4 34.6245 5.26975 16.1857 -14.4704 2.64329 20.4158 +4385 4 33.4298 5.20109 17.2262 -20.6176 -11.2241 -0.901893 +4386 6 14.7832 27.6655 0.085624 -10.3553 13.8949 -22.792 +4387 4 14.1034 27.8892 41.3249 2.03342 -11.2849 14.5146 +4388 4 15.1757 28.5319 0.287496 2.39463 -6.00136 9.68974 +4389 6 48.8635 15.5211 20.7504 -7.30397 3.37214 15.1279 +4390 4 49.1252 16.3754 20.4371 0.183023 13.7927 -3.76167 +4391 4 49.1585 14.9241 20.0762 3.93917 -17.6947 -14.7742 +4392 6 23.8074 40.3851 20.3877 -2.3041 21.5375 32.1864 +4393 4 23.5266 40.991 21.1382 8.45078 -18.9812 -28.3519 +4394 4 24.6929 40.0818 20.645 -4.8729 5.63426 -4.96266 +4395 6 35.18 31.4993 13.7142 -38.6695 32.0432 -41.3249 +4396 4 34.2219 31.3119 13.4889 30.0091 9.93153 3.95626 +4397 4 35.4367 30.7845 14.243 12.3636 -35.8089 30.5679 +4398 6 10.9775 9.01115 39.5206 -26.3812 35.8658 -19.2594 +4399 4 10.5557 9.91556 39.5205 15.5031 -28.3669 -8.85108 +4400 4 11.1542 8.87096 40.4393 5.31517 -3.54045 10.232 +4401 6 53.2061 4.88103 16.6049 -20.6689 -12.7794 3.6937 +4402 4 53.6782 5.3887 17.2239 33.7717 25.1716 19.5104 +4403 4 52.5676 4.51498 17.2255 -11.3933 -13.1169 -19.2452 +4404 6 7.83562 33.8039 26.1496 42.0062 50.3869 -17.047 +4405 4 7.62463 34.1533 27.0155 -6.33847 -9.39794 9.82588 +4406 4 8.42034 34.5749 25.7852 -30.6961 -50.8642 6.91563 +4407 6 31.3279 27.9472 6.28298 4.37835 -19.3247 -9.6219 +4408 4 31.922 27.5111 6.93657 -10.4846 5.09347 -11.9486 +4409 4 31.1129 27.3323 5.53276 6.79934 9.76999 15.6259 +4410 6 31.3655 2.17383 41.055 18.9421 -1.98994 34.5993 +4411 4 31.8109 2.17902 0.04034 -17.0754 7.04602 -28.7946 +4412 4 31.2404 1.23747 40.9086 -7.00813 -7.80206 -8.22245 +4413 6 33.7652 4.25739 35.9001 -31.2863 -13.3655 20.8802 +4414 4 34.2485 3.80076 36.6104 5.56552 8.36292 -9.80816 +4415 4 32.8077 4.13792 36.1863 30.7439 3.51509 -16.9094 +4416 6 47.9725 16.0636 29.8584 -12.289 -4.0311 -5.35812 +4417 4 48.7208 16.4163 30.3732 -4.13056 -10.8519 0.408936 +4418 4 47.3533 15.5947 30.4559 16.7379 8.85318 -0.563064 +4419 6 49.3385 10.0935 28.5885 -11.8118 4.56009 -13.0989 +4420 4 48.5886 10.6638 28.8239 3.51911 -4.5157 1.44109 +4421 4 49.3924 10.1159 27.6088 6.69909 -1.91925 15.8757 +4422 6 21.4187 27.7693 29.76 2.80336 -20.4787 -6.37736 +4423 4 21.861 27.2354 30.4624 -7.84738 15.6574 -13.8161 +4424 4 21.1828 28.6282 30.0799 2.10219 20.3695 17.9057 +4425 6 11.6757 39.482 25.8517 13.5538 20.9417 -1.29545 +4426 4 12.2965 38.7786 26.0889 -7.12508 -2.9493 -2.05027 +4427 4 10.8193 39.0846 25.7116 -11.9056 -6.20494 0.0112269 +4428 6 22.9798 39.311 7.85817 -12.7601 -4.86939 -3.04246 +4429 4 22.3059 38.6219 7.95844 1.92638 3.98273 0.136758 +4430 4 22.5772 40.0658 8.31757 9.04497 -1.85468 3.82529 +4431 6 42.5415 35.9278 31.3391 13.0935 -70.9729 -20.1514 +4432 4 42.6447 35.4696 30.4714 -5.52665 5.17936 25.8951 +4433 4 42.5102 36.7973 31.0384 -8.93799 60.9387 2.27408 +4434 6 33.663 14.7412 3.98499 30.4225 -17.693 -39.6888 +4435 4 32.8564 15.2185 4.09596 -24.3526 16.5192 2.50389 +4436 4 33.8944 14.7916 3.00116 -11.9532 1.40502 32.6284 +4437 6 36.697 8.6017 17.5153 18.7294 -29.9333 -4.55465 +4438 4 37.1702 7.95911 16.9159 -11.687 24.5338 13.7544 +4439 4 36.2734 9.25409 16.9543 -7.54123 3.80926 -6.08989 +4440 6 20.8295 32.4146 17.3309 -48.7404 -21.5825 11.0081 +4441 4 20.1664 32.9726 16.9048 10.2664 9.72211 -3.82622 +4442 4 20.2271 31.8015 17.8465 35.2036 12.7196 -8.50107 +4443 6 20.7003 35.3218 14.1083 -3.44914 -18.0461 -19.2112 +4444 4 21.3182 35.5386 13.4099 3.08163 2.90557 -13.4495 +4445 4 20.919 35.9437 14.7754 1.56244 13.5022 22.2067 +4446 6 20.2323 2.51936 40.1651 -9.22326 -14.3688 36.1644 +4447 4 19.7926 2.34354 41.0434 13.5524 6.30823 -28.5037 +4448 4 20.7516 1.7186 40.0171 -1.27786 1.50094 -7.75906 +4449 6 15.0477 14.4672 0.24789 12.9865 -5.55034 -72.7807 +4450 4 15.4827 13.6954 41.6877 -12.87 20.0829 29.6139 +4451 4 15.2186 15.2036 41.5094 -2.93016 -13.2387 23.097 +4452 6 24.8149 37.3373 18.5213 2.43631 -2.68492 27.9859 +4453 4 24.4361 37.9203 17.8611 -0.249038 9.91659 1.71419 +4454 4 24.5604 37.6468 19.4234 0.486379 -6.00228 -23.279 +4455 6 3.16989 27.7944 5.24229 1.80682 -16.6913 61.515 +4456 4 2.664 27.92 6.09489 -0.254446 2.50987 -32.3978 +4457 4 4.0252 27.4816 5.63916 -14.135 1.37322 -28.2843 +4458 6 37.1257 39.0598 36.0573 4.58816 40.5807 23.3296 +4459 4 37.5599 39.5885 36.7783 -22.7086 -1.13864 -22.8071 +4460 4 37.5439 38.2379 36.1828 13.5973 -37.3165 -5.96047 +4461 6 41.3477 16.3672 3.84024 25.8131 6.72768 37.2631 +4462 4 41.4431 17.3182 3.89206 -17.3786 8.01961 -13.1803 +4463 4 42.0046 16.1549 4.54461 -14.0821 -19.2698 -21.0799 +4464 6 15.5755 3.1684 35.3585 1.47298 2.70845 -61.2084 +4465 4 15.1145 3.59171 34.5864 10.479 -16.2188 17.3147 +4466 4 15.2032 3.60881 36.0782 -15.9672 22.7619 40.5269 +4467 6 33.1731 24.2438 7.96729 6.41569 -10.7526 14.1331 +4468 4 33.3408 24.6773 7.1445 11.9115 -7.07525 -26.7187 +4469 4 32.5824 24.8707 8.33408 -19.4303 14.6961 21.7816 +4470 6 35.865 29.7374 15.5979 -29.8607 35.3275 -32.1308 +4471 4 36.7747 29.6672 15.7703 43.701 -12.5229 16.5971 +4472 4 35.3562 29.0371 15.9739 2.56537 -15.478 18.0667 +4473 6 17.5843 36.8354 41.8728 12.1708 -5.57123 -52.5088 +4474 4 18.1833 36.773 0.675699 12.2604 -1.93512 36.5948 +4475 4 18.2359 36.8623 41.125 -21.8566 7.06165 11.6698 +4476 6 26.5622 4.14672 31.1307 -32.6289 -51.1506 -31.7953 +4477 4 27.2582 4.59627 31.5457 41.9615 24.0313 17.3243 +4478 4 26.8928 3.23766 30.8727 -4.86114 29.783 15.5489 +4479 6 31.9552 1.33198 34.4369 -14.3248 -8.90334 35.5546 +4480 4 32.7269 1.15305 34.9944 8.32726 6.02564 -17.2377 +4481 4 31.2642 1.08685 35.0838 -0.545778 4.81468 -20.3916 +4482 6 24.491 14.7534 2.38457 33.2042 -23.9469 17.2683 +4483 4 24.2753 13.9637 2.92779 -7.56186 18.0622 -11.5291 +4484 4 25.4626 14.8414 2.55985 -20.2114 8.54272 -9.97318 +4485 6 25.7566 20.9055 27.5389 -1.15091 7.1508 6.95521 +4486 4 25.459 20.6057 28.4261 8.17968 -1.38894 -17.9407 +4487 4 25.6371 21.8685 27.5748 1.97223 -1.15564 -2.97875 +4488 6 18.1445 40.1527 30.6395 17.3729 -20.3781 15.2884 +4489 4 18.5141 39.2638 30.8544 -10.5973 16.1604 -9.36512 +4490 4 18.9393 40.7073 30.6583 -6.94059 7.54086 -5.9327 +4491 6 46.7889 23.8914 24.5979 7.31075 41.4222 -46.8858 +4492 4 46.2898 24.602 24.0741 10.6002 -32.8666 22.2289 +4493 4 47.4121 23.5287 23.9473 -6.99108 -0.957122 4.26591 +4494 6 45.6201 22.6921 26.5067 -14.1777 -10.0967 -12.8229 +4495 4 46.0372 22.9342 25.6668 -2.41585 -1.26552 16.8561 +4496 4 46.0784 23.1676 27.2003 -0.61408 1.28207 1.11474 +4497 6 20.1006 4.48803 26.6974 -40.8522 40.1383 42.8029 +4498 4 20.2489 5.43817 26.4853 8.37449 -26.4011 -0.951475 +4499 4 20.6602 3.93368 26.2205 34.0606 -24.4352 -38.1565 +4500 6 35.278 26.5864 12.552 0.280065 20.4825 10.9931 +4501 4 35.6728 25.7022 12.4634 2.08478 13.3641 8.87461 +4502 4 35.7774 27.1222 13.2104 -5.20465 -19.6779 -15.4464 +4503 6 3.25879 33.9669 12.2907 -5.01808 -25.4739 5.3677 +4504 4 2.34263 33.6224 12.3201 4.20809 12.7539 -0.381501 +4505 4 3.26735 34.9165 12.3326 -4.58918 17.9212 0.78916 +4506 6 36.6873 1.27899 25.5756 -31.8717 2.25298 32.7844 +4507 4 37.6116 1.37326 25.7779 18.4499 5.6721 -4.77344 +4508 4 36.2122 1.51788 26.4163 6.97172 -2.04149 -25.7728 +4509 6 16.8705 4.65685 24.0413 -35.5309 2.76318 -23.9776 +4510 4 15.8575 4.70434 23.9217 47.0687 -0.0954558 1.21401 +4511 4 17.247 4.33879 23.186 -5.50277 -2.28941 17.9023 +4512 6 39.6565 15.0715 7.80572 25.6093 19.6796 32.1194 +4513 4 39.2854 14.2576 8.13712 -9.42359 -13.1845 -9.18942 +4514 4 39.3628 15.2517 6.91527 -5.26665 -12.4192 -5.15573 +4515 6 9.97948 20.1659 2.91877 -9.38613 14.9664 11.2777 +4516 4 9.63877 20.6452 2.15027 4.12295 -11.9706 -3.67253 +4517 4 9.85969 19.2106 2.80597 1.71997 13.0916 -4.74013 +4518 6 23.4135 4.6314 15.2717 1.19087 -47.3757 24.1847 +4519 4 23.6596 4.57091 14.3636 3.27412 12.4021 -25.8415 +4520 4 23.0767 5.481 15.4712 -5.64379 31.4202 -0.243197 +4521 6 23.5143 41.6409 17.9193 15.1077 8.25095 -6.6202 +4522 4 23.8837 41.2632 18.7444 -17.9015 4.85421 -1.14363 +4523 4 22.6477 0.129763 18.1032 2.89941 -5.9973 3.37217 +4524 6 30.9257 4.8197 1.33225 52.4556 82.2644 21.8498 +4525 4 30.6067 4.04082 1.0087 -28.5575 -73.6424 -29.1188 +4526 4 31.8008 4.99709 0.898826 -20.2281 -12.9509 7.44496 +4527 6 29.2107 33.7595 18.6102 73.0072 -21.2941 -2.29721 +4528 4 30.2072 34.0216 18.5444 -47.9733 -6.17517 5.28057 +4529 4 28.7323 34.5281 18.37 -21.0864 31.3556 1.11974 +4530 6 23.1159 16.7161 3.6681 15.0693 -22.2232 4.2808 +4531 4 23.7494 16.3853 2.99745 -15.1451 3.0429 8.25243 +4532 4 23.0882 17.666 3.59926 -2.15966 11.8771 -4.335 +4533 6 34.9011 26.7664 31.7501 -1.76717 8.52767 -40.8429 +4534 4 35.037 27.6398 31.3273 1.29043 -2.59798 26.5044 +4535 4 34.999 26.223 30.9552 -0.698038 -3.54606 8.98008 +4536 6 7.10213 40.7731 20.9713 24.4432 1.2064 -5.23395 +4537 4 6.57619 40.3882 20.2802 -20.054 -4.79313 -9.64846 +4538 4 7.95521 40.8692 20.51 0.818491 4.17448 7.60026 +4539 6 52.4557 9.69054 11.9333 -13.8891 -19.4181 -13.3487 +4540 4 52.1298 8.88818 11.4535 9.48574 25.0976 13.8313 +4541 4 53.1611 10.0725 11.3936 -7.122 -1.8527 1.23238 +4542 6 12.0235 32.7598 27.7442 3.70099 -7.78602 -3.89203 +4543 4 11.3626 32.1501 27.3892 -5.86407 9.3821 3.02313 +4544 4 12.7405 32.6461 27.1218 9.18069 3.19616 2.31322 +4545 6 15.7918 18.546 0.850378 10.8461 -1.95532 -11.5883 +4546 4 16.438 18.9813 1.41668 1.29405 -2.87095 0.147979 +4547 4 14.9753 18.6242 1.3119 -21.1882 -0.0291689 9.92309 +4548 6 30.9967 13.9378 7.42939 11.475 1.61738 -44.5395 +4549 4 31.0432 13.5913 6.48715 -7.7997 1.97415 36.5778 +4550 4 31.6719 14.6391 7.43931 -7.46887 -7.66354 10.6483 +4551 6 23.9383 39.564 3.55488 34.3001 -22.0749 -10.0269 +4552 4 24.3437 38.8163 4.07249 -17.2972 16.8542 -11.2744 +4553 4 24.6493 39.7352 2.88999 -19.8697 7.819 10.5959 +4554 6 53.2452 13.9576 2.00229 -14.7116 -5.90049 -8.44118 +4555 4 54.0493 14.3984 2.24709 19.6807 0.169927 9.22775 +4556 4 52.9645 14.4205 1.20429 2.95034 -7.59818 -1.70329 +4557 6 29.4557 26.4275 7.80964 12.1022 6.02758 -9.79702 +4558 4 29.9353 26.7368 7.00545 -17.6775 -4.91001 19.2628 +4559 4 28.525 26.2807 7.58748 -5.08244 6.84096 -3.37299 +4560 6 24.6247 23.6022 31.0889 -22.8452 23.3962 -39.3716 +4561 4 23.7242 23.1866 30.9343 31.0198 16.8155 5.56769 +4562 4 24.7802 24.3072 30.3632 -7.32447 -41.3429 34.091 +4563 6 33.6649 19.3163 40.5091 -6.65541 -1.27585 7.81728 +4564 4 33.8354 18.657 41.2044 -1.67667 1.74775 -3.87809 +4565 4 34.3105 19.1562 39.8145 2.0445 4.20075 -4.1701 +4566 6 0.559384 35.9874 14.2134 5.8565 -19.6842 -1.82955 +4567 4 1.23941 35.9463 14.8996 -3.202 15.0395 2.84586 +4568 4 0.030681 36.7785 14.2979 -4.01885 14.7851 6.49139 +4569 6 7.05661 12.759 15.7779 -22.8667 -6.52104 17.6379 +4570 4 6.34583 12.5966 16.4564 20.9558 0.33122 -21.552 +4571 4 6.91757 12.0848 15.0954 -2.34629 3.44815 6.08752 +4572 6 7.88282 3.87818 22.4173 5.89555 -44.5054 15.1514 +4573 4 7.49019 4.56914 21.9267 -7.80716 26.896 -25.5563 +4574 4 7.61791 3.03791 21.9647 5.08594 18.6769 15.1101 +4575 6 50.7471 32.0888 16.2401 1.83727 42.1646 -7.06137 +4576 4 49.8752 31.8312 16.5285 -7.29916 -4.21179 -0.512004 +4577 4 50.6362 33.057 15.9791 5.96194 -37.4522 8.78354 +4578 6 15.303 18.2089 30.059 10.7923 -22.0796 25.2673 +4579 4 14.9011 18.5061 29.2675 -14.0638 14.0876 -27.3921 +4580 4 14.9173 17.3208 30.1974 9.34767 8.93092 3.04247 +4581 6 36.7231 25.4597 33.3812 -54.2725 16.2506 -34.9161 +4582 4 35.9173 25.838 32.8237 55.5216 -11.0114 39.6871 +4583 4 36.747 24.5432 33.1027 5.79642 -6.85026 5.14009 +4584 6 16.5358 21.8507 20.2615 -17.2006 3.10996 -10.5852 +4585 4 16.5318 20.9271 19.9881 4.62491 -6.39719 -1.16283 +4586 4 16.2171 22.3466 19.4835 8.40466 -0.269645 8.83911 +4587 6 44.2784 3.11614 30.075 -4.29151 -10.9085 31.9498 +4588 4 44.2908 2.23086 29.7056 -5.3385 -9.83615 -1.81045 +4589 4 44.5205 3.68982 29.3775 9.49019 22.102 -29.428 +4590 6 51.0822 14.1295 27.7742 -18.732 -33.3382 -1.30318 +4591 4 51.215 15.0658 27.7997 -1.99026 24.8352 -0.164216 +4592 4 50.1181 13.9695 27.6298 18.0185 9.91077 0.913588 +4593 6 54.1414 15.8836 27.1251 18.1892 -50.717 -21.9912 +4594 4 54.5758 14.9905 27.2793 -7.90108 34.3346 13.352 +4595 4 53.8259 15.7459 26.2068 -12.5208 17.6482 15.4671 +4596 6 26.7107 15.1629 34.529 26.3006 32.6175 -12.2305 +4597 4 26.7089 16.144 34.4655 -8.86078 -18.0829 7.52702 +4598 4 27.5163 14.9973 34.009 -10.4907 -11.0891 -0.654257 +4599 6 34.6699 2.22267 27.4725 27.1341 -12.2799 29.337 +4600 4 34.3153 1.93716 28.3227 7.08088 3.88889 7.09202 +4601 4 33.8991 2.25298 26.9555 -28.541 9.30381 -28.496 +4602 6 36.3083 17.6409 40.3953 7.68303 1.60807 9.57574 +4603 4 35.716 17.1791 39.8253 -12.5236 -4.37947 -14.4862 +4604 4 36.6569 16.9265 40.9504 1.18426 15.263 2.6664 +4605 6 26.2972 0.194896 33.0957 0.945324 -1.75644 -10.1569 +4606 4 26.0926 0.771392 33.8475 -8.68516 2.0119 1.91424 +4607 4 25.4691 41.6865 32.8295 -8.00507 -1.67316 12.192 +4608 6 5.19113 35.5773 31.6357 23.2413 -27.7984 27.0466 +4609 4 6.1476 35.7159 31.7435 -10.1506 4.22761 6.12862 +4610 4 4.96861 36.095 30.8978 -11.7512 22.2076 -38.0194 +4611 6 20.2191 22.0354 35.1304 9.30742 -6.19625 19.4235 +4612 4 19.9844 21.2003 34.7289 -5.16022 -6.81034 -3.33987 +4613 4 20.4782 21.7596 36.0473 -3.02096 9.85719 -25.9724 +4614 6 15.9251 36.5949 36.947 -9.13121 -30.7472 31.1466 +4615 4 16.4837 37.3712 37.0549 6.13876 -3.03661 -2.05614 +4616 4 16.031 36.0658 37.8159 -5.1453 16.1721 -39.9007 +4617 6 30.9484 22.4015 3.56131 11.993 -60.8988 -15.4947 +4618 4 31.1008 22.6958 4.44557 1.55935 5.74187 27.4751 +4619 4 31.2551 21.4217 3.58407 -13.4398 43.4536 -6.61432 +4620 6 47.0429 8.40936 14.2086 -4.42011 -15.6298 -34.0486 +4621 4 46.2603 8.29509 13.606 17.325 5.05196 18.7602 +4622 4 47.7698 7.89697 13.7682 -18.8904 11.0332 12.0247 +4623 6 34.1011 18.6159 3.148 0.361877 23.965 35.4915 +4624 4 34.6363 18.3397 3.89922 -0.845538 -0.743075 -4.07575 +4625 4 34.3812 18.1265 2.40098 2.04544 -17.9565 -29.3984 +4626 6 26.7996 25.3961 12.3408 -30.8906 -54.2954 26.5725 +4627 4 27.3117 26.1608 12.4557 20.536 44.4803 3.39785 +4628 4 26.6414 25.0259 13.2528 6.28377 9.49183 -30.6151 +4629 6 22.6108 25.7845 30.8845 17.3255 -0.303924 3.7754 +4630 4 23.4288 25.6954 31.4132 -11.344 -1.13015 -1.03332 +4631 4 22.2314 24.9052 30.7722 1.09512 -5.6623 7.4309 +4632 6 23.6311 9.76276 35.7585 -2.90797 -4.19552 -4.78319 +4633 4 22.8314 10.2832 35.6581 -5.74139 5.63622 4.02691 +4634 4 23.3139 8.86685 35.4998 11.2809 19.0625 6.63709 +4635 6 10.4076 36.7742 9.64242 -28.436 -9.9846 9.32351 +4636 4 9.50067 36.3875 9.59353 19.7531 11.7612 -0.53903 +4637 4 10.7226 36.8301 8.7426 3.69205 5.92187 -13.8772 +4638 6 4.00038 32.4265 25.8669 22.0714 10.4661 11.4497 +4639 4 4.38844 32.9375 25.1422 -1.34031 3.54398 1.69886 +4640 4 3.2706 31.9516 25.4996 -17.8371 -17.4963 -10.4987 +4641 6 29.085 26.0296 18.6527 19.273 -47.5776 11.2122 +4642 4 28.2115 26.0231 19.0264 -21.1607 3.13806 -0.423844 +4643 4 29.4632 25.1291 18.9323 -7.10954 42.4601 -14.5827 +4644 6 15.3089 1.3255 27.9792 -24.1234 20.5069 -17.5654 +4645 4 15.0496 0.974163 27.1169 2.04641 -4.01433 11.5068 +4646 4 14.7355 2.12388 28.0804 19.9995 -12.8223 4.08523 +4647 6 48.6106 2.88816 22.9655 -1.26722 3.55247 -0.201848 +4648 4 48.4165 2.02818 22.6182 -14.5439 -12.5884 3.03438 +4649 4 49.5001 2.98572 22.6432 10.4652 10.9023 -5.33271 +4650 6 53.0075 0.36099 19.7296 11.424 -8.43987 -8.95848 +4651 4 52.5965 41.9022 20.5162 -3.41206 4.78179 6.33318 +4652 4 52.3731 0.223553 19.0136 -6.83989 5.16364 0.289704 +4653 6 1.41074 17.5036 17.9462 -15.7932 -16.9445 -5.36496 +4654 4 1.29993 17.3585 17.0019 -2.92928 12.5396 -5.88676 +4655 4 1.38271 16.6004 18.2823 6.65411 -3.00458 14.0519 +4656 6 37.9084 19.0323 37.6056 -38.9323 8.68785 -13.5971 +4657 4 36.9858 18.7285 37.7384 11.3307 8.89304 -0.372118 +4658 4 38.4207 18.4342 38.1195 19.3518 -17.7067 16.118 +4659 6 26.9813 30.3571 38.0896 -0.527767 18.5171 -30.3811 +4660 4 26.1212 30.285 37.6565 1.23907 -9.17466 9.80696 +4661 4 27.2764 31.2069 37.701 2.1524 -13.2267 12.8694 +4662 6 20.0955 18.5722 3.03696 10.9017 21.9571 9.92937 +4663 4 20.0263 17.806 3.59422 -10.4522 -23.2015 2.62566 +4664 4 20.8322 19.0363 3.46766 -4.52129 0.073665 -16.3651 +4665 6 35.0841 6.94694 4.08385 8.40312 -14.6319 10.4582 +4666 4 35.6826 7.16069 3.3578 -1.64356 4.34706 -6.00978 +4667 4 34.2613 7.42764 3.99145 -7.61312 4.93718 -6.31016 +4668 6 22.2176 37.0878 31.2599 -35.8324 13.882 69.7054 +4669 4 22.1593 36.8558 30.3798 -4.04212 -13.8909 -61.3413 +4670 4 21.2552 37.1952 31.5589 44.4461 1.84169 -14.4682 +4671 6 12.3904 22.3711 41.8265 33.9103 21.3816 -17.5574 +4672 4 13.0623 23.0096 41.4404 -31.3175 -17.017 24.3472 +4673 4 11.7392 22.2302 41.1411 -5.71588 1.3909 -0.895108 +4674 6 43.2333 30.3145 23.1566 26.412 30.0652 1.94466 +4675 4 44.1443 29.9954 22.911 -23.9673 11.2944 4.28313 +4676 4 43.3588 31.2906 23.3811 -4.98348 -33.6726 -4.24118 +4677 6 16.5316 8.07904 16.6592 -13.1305 -2.58289 1.30551 +4678 4 16.426 8.46358 15.7881 -7.07274 -4.02537 -8.52635 +4679 4 17.4421 8.27811 16.8595 11.8389 2.77268 11.6749 +4680 6 10.0527 8.64979 31.7837 -8.97334 17.7557 -57.5223 +4681 4 10.1312 7.90747 32.3291 5.58005 -27.1767 37.8097 +4682 4 10.1183 9.47003 32.2578 1.92783 9.29621 23.4619 +4683 6 10.1389 6.52097 25.6279 25.2027 -9.57639 0.964906 +4684 4 9.42987 6.19895 26.1639 -19.2857 -8.54063 7.31181 +4685 4 9.7626 7.17299 25.0306 4.07146 -2.80849 4.96109 +4686 6 49.8614 7.23714 25.5252 -17.9172 7.62946 -5.56104 +4687 4 50.0467 6.31121 25.4422 2.69032 -18.6529 -6.42341 +4688 4 50.6907 7.63095 25.75 18.9978 12.6416 8.6826 +4689 6 18.4677 37.5766 33.9365 -27.5019 7.45217 1.11424 +4690 4 17.6855 38.1606 34.0956 24.1544 -3.52274 -4.16364 +4691 4 18.0518 36.7105 34.0373 4.53854 -5.63623 -1.47673 +4692 6 32.1991 34.7999 39.2511 37.7035 -28.7103 22.0041 +4693 4 32.3976 34.2973 40.087 0.14143 15.1618 -21.7552 +4694 4 31.3182 35.0784 39.3573 -42.2601 10.9481 4.26487 +4695 6 49.5371 23.9083 4.45427 26.1113 1.30104 -36.4507 +4696 4 49.7626 23.2251 5.06121 8.22711 -23.3511 16.8473 +4697 4 48.7895 24.3154 4.8182 -37.5883 23.1909 21.4935 +4698 6 6.05615 24.4755 33.9372 -3.62864 21.1406 1.2609 +4699 4 6.78781 23.8493 33.8811 -5.98028 -5.90455 -1.42734 +4700 4 5.44033 24.2071 34.6424 10.5748 -4.32926 -7.84557 +4701 6 1.71417 22.9797 24.1919 12.9465 25.751 -13.942 +4702 4 1.74027 23.9063 23.8744 -7.21984 -9.04225 7.93975 +4703 4 0.785802 22.7901 24.3299 -10.4675 -5.82386 8.34916 +4704 6 12.4544 16.5695 32.338 -33.1179 2.9171 31.5337 +4705 4 13.1434 15.995 32.5512 52.391 -27.2499 -12.3732 +4706 4 11.9701 16.4097 33.1768 -13.251 25.8897 -21.4653 +4707 6 21.3776 37.3784 27.9508 -6.73969 12.2577 23.3137 +4708 4 21.2203 37.3231 27.0262 1.16773 -1.52428 -34.5533 +4709 4 20.718 38.0458 28.2038 6.71566 -1.73666 8.03222 +4710 6 27.2299 40.8388 28.8031 2.48401 0.937021 1.60569 +4711 4 26.5367 41.5089 28.9565 6.65702 -12.2841 2.86921 +4712 4 27.4065 40.3185 29.6035 -12.9999 8.55112 -0.224288 +4713 6 0.993205 21.7261 13.5372 -53.3037 2.48171 -36.3839 +4714 4 1.86429 21.8093 13.8237 52.7771 -6.56786 29.3883 +4715 4 0.417346 21.4203 14.2472 8.63216 3.11646 10.526 +4716 6 22.3067 2.58146 8.73662 29.448 -13.2509 35.6107 +4717 4 22.9722 3.05705 8.24165 5.16658 9.50374 -8.2335 +4718 4 21.5154 2.5876 8.23764 -24.8297 4.23497 -21.3736 +4719 6 29.9953 17.8456 8.24313 -2.433 8.62767 -9.90081 +4720 4 29.054 17.6713 8.30654 -5.44558 -4.70631 2.21427 +4721 4 30.3746 17.4275 9.01982 5.69521 -3.15286 8.62416 +4722 6 3.62819 37.7118 25.7099 -17.1271 -24.8271 -10.3244 +4723 4 4.40422 37.1524 25.7956 9.9921 4.76654 4.66524 +4724 4 2.941 37.0477 25.4485 4.12723 25.8155 6.09629 +4725 6 26.809 27.648 36.3589 -37.7802 -17.2474 29.8166 +4726 4 26.8014 28.1831 35.5758 -1.13827 16.217 -13.4241 +4727 4 25.8725 27.5642 36.7259 28.3017 7.35189 -21.1707 +4728 6 13.3559 25.3099 38.116 1.93465 -14.8526 16.0582 +4729 4 13.2959 24.3789 38.4372 3.98877 20.6101 -4.99041 +4730 4 14.1146 25.694 38.605 -5.66874 -3.07699 -9.11419 +4731 6 49.7048 27.2599 6.72622 -1.43928 22.3256 -10.7839 +4732 4 49.6686 26.3369 6.45132 -5.99645 4.70457 -4.8273 +4733 4 49.2845 27.8697 6.04945 8.54794 -27.7312 19.0533 +4734 6 39.7449 11.5776 10.1987 6.84991 -8.95817 -1.04181 +4735 4 40.3059 10.8428 9.86803 -8.86198 19.4731 1.33094 +4736 4 39.0907 11.7833 9.50723 6.52335 -1.56097 1.75374 +4737 6 17.4857 24.9907 35.5559 -11.6728 -0.232318 -1.23817 +4738 4 17.2359 24.7743 34.6481 -9.71541 0.96097 3.2925 +4739 4 18.4326 24.9281 35.5495 18.729 -4.76527 0.24637 +4740 6 45.0886 34.9858 31.8393 -13.7853 -2.59791 -12.3576 +4741 4 44.2542 35.4282 32.0247 4.31579 11.0194 10.5125 +4742 4 44.8031 34.4855 31.0733 13.3341 -13.9746 -4.20839 +4743 6 30.2109 9.89077 31.3202 8.39813 20.0527 10.0978 +4744 4 30.4343 10.7522 30.9233 -1.69236 -11.2354 5.34707 +4745 4 30.0976 10.0887 32.2697 2.61193 -8.5831 -6.90929 +4746 6 32.3748 9.22464 6.61109 37.8815 -39.2378 -50.8405 +4747 4 32.2118 8.68084 5.76454 4.57858 20.451 35.1159 +4748 4 31.5433 9.4233 6.96427 -45.6188 15.529 19.6617 +4749 6 9.26845 24.9782 35.9229 1.19564 -9.02769 -15.4958 +4750 4 8.9564 25.4582 35.1216 5.49795 -4.99978 19.1154 +4751 4 9.87718 25.5584 36.4061 -8.42028 -2.10732 -11.5846 +4752 6 40.3335 1.48296 18.8902 20.9136 0.652934 -58.3414 +4753 4 39.6207 1.94237 19.2768 -32.228 11.5513 31.9135 +4754 4 40.836 0.952532 19.4949 5.43911 -12.9068 21.333 +4755 6 5.27733 10.6166 30.4293 -4.37857 29.6514 35.8012 +4756 4 5.00531 11.4476 30.0112 -0.880507 -1.63534 -8.13264 +4757 4 5.35863 10.9185 31.3957 -0.759826 -20.4729 -25.7258 +4758 6 25.6655 11.6994 25.6535 -15.8411 -39.3949 6.40341 +4759 4 25.8392 12.448 26.1908 9.94197 23.9877 11.5846 +4760 4 25.8146 10.9427 26.2759 4.01869 23.17 -23.7809 +4761 6 21.9208 20.0736 29.783 -0.661059 -23.1285 25.9828 +4762 4 22.5528 19.9674 30.5279 -9.0028 12.6586 -11.845 +4763 4 21.4796 19.2024 29.7633 3.30396 8.80601 -15.8778 +4764 6 10.0031 19.9894 34.5062 10.0701 -18.9504 -1.84201 +4765 4 9.43917 20.4787 35.093 -9.85162 7.82768 6.06887 +4766 4 9.97528 19.0642 34.823 3.96148 11.1077 -9.79004 +4767 6 24.6395 10.3611 12.2013 10.4056 19.7725 40.7349 +4768 4 24.7062 9.53294 12.699 -2.91134 1.50973 -12.3578 +4769 4 25.0089 11.0108 12.8733 -15.5791 -20.8054 -25.2752 +4770 6 50.4386 28.2959 11.551 52.3964 -11.4141 -41.8896 +4771 4 51.2944 28.7096 11.1811 -37.3824 -15.4271 20.8858 +4772 4 50.1484 28.8694 12.238 -9.02874 19.1251 18.783 +4773 6 13.9255 27.6321 25.0575 -30.7043 9.27758 -16.9407 +4774 4 13.4685 27.961 25.8505 6.53671 1.50814 -8.33226 +4775 4 13.405 28.0084 24.2853 19.6442 -13.6277 24.9436 +4776 6 46.1675 18.6723 40.4127 -24.7255 0.52235 -5.51451 +4777 4 45.2163 18.6287 40.1471 17.8616 -3.70574 0.193046 +4778 4 46.2526 19.5549 40.792 -2.63441 -2.56699 -8.45512 +4779 6 32.4875 14.1744 27.1342 -20.1773 -0.115465 -0.458595 +4780 4 31.894 13.6021 27.6676 10.0212 10.5514 -7.27374 +4781 4 32.1329 15.0809 27.2203 4.74838 -8.22403 2.71507 +4782 6 14.0641 36.351 13.3878 -9.69625 43.6715 -7.48797 +4783 4 14.0645 37.3444 13.3555 12.262 -25.9465 20.9036 +4784 4 13.2835 36.2347 12.8457 -5.28255 -22.0231 -7.64651 +4785 6 1.89477 36.5899 21.9857 -12.7075 -7.68583 0.53673 +4786 4 1.75133 36.5712 22.9388 2.01013 -3.06644 8.01032 +4787 4 2.81569 36.8315 21.8421 3.36212 -1.19737 0.805445 +4788 6 25.2943 31.8607 39.7417 -2.48011 0.614033 34.0265 +4789 4 24.999 32.7283 39.4716 -5.73903 6.77443 -6.35095 +4790 4 25.461 31.9431 40.7124 0.191009 -4.33082 -23.8473 +4791 6 6.4797 22.0186 1.29894 -12.0535 -14.7769 -6.17691 +4792 4 5.53353 21.8063 1.36197 11.0348 5.26157 5.70773 +4793 4 6.5732 22.8347 0.80957 1.58971 11.8894 0.78955 +4794 6 27.6266 25.0275 4.69979 7.76412 30.8855 29.066 +4795 4 28.5017 25.4862 4.66738 -16.9061 -15.4428 -5.02391 +4796 4 27.2115 25.3905 5.52919 8.95609 -10.8934 -21.2922 +4797 6 21.6474 30.9429 41.2213 -14.674 16.9935 -31.5335 +4798 4 21.3077 30.3434 41.8509 -10.7705 -24.5884 29.0962 +4799 4 20.9035 30.9616 40.5667 22.5963 5.39714 5.21952 +4800 6 32.3503 18.8691 12.7728 -7.52429 -0.383917 -18.241 +4801 4 31.3918 18.9773 12.8161 6.27066 1.36054 6.85895 +4802 4 32.4619 18.5656 11.8564 12.6246 0.663961 8.91714 +4803 6 35.6352 19.4593 21.1461 -10.1734 29.4522 17.7801 +4804 4 35.3511 18.62 21.5049 -2.07097 -11.6796 -4.30053 +4805 4 34.9906 20.1214 21.5255 16.9121 -20.2959 -15.2058 +4806 6 27.6974 17.9478 34.0105 3.72497 22.7808 11.4532 +4807 4 28.1244 18.3695 33.2449 -3.6365 -3.33971 3.70746 +4808 4 28.0134 18.5196 34.7467 -3.33496 -14.4526 -11.1074 +4809 6 34.1722 39.0415 14.8025 -0.588556 -5.09353 50.87 +4810 4 33.8492 38.3378 14.2426 -9.69809 -4.78927 -2.35124 +4811 4 33.6075 39.0103 15.6476 14.9636 10.6202 -38.8415 +4812 6 28.5063 3.47722 33.8826 -13.8698 -21.2799 4.06498 +4813 4 27.871 4.20321 33.9085 6.20243 8.28698 -1.91661 +4814 4 29.4175 3.76621 33.9059 10.9167 16.0273 -3.84391 +4815 6 34.9231 32.1486 6.55347 -48.5451 -22.9266 3.43697 +4816 4 33.9921 31.9748 6.9467 49.872 11.9331 -17.2337 +4817 4 35.5478 32.1135 7.28146 1.17984 3.66225 6.53991 +4818 6 31.8923 6.87344 23.517 2.73099 13.3553 4.48118 +4819 4 32.4005 6.72509 22.7097 -0.163961 -9.68163 3.8586 +4820 4 32.2042 7.75277 23.812 -2.19309 -5.80853 -1.60196 +4821 6 18.8495 1.74691 0.846251 -10.8424 6.73855 -33.2301 +4822 4 18.128 2.12906 0.287715 7.30697 -5.37966 19.0723 +4823 4 19.1812 2.42034 1.43504 -3.90896 9.02122 12.2654 +4824 6 27.0029 18.9235 11.8738 61.7268 20.0146 -35.0636 +4825 4 27.2277 19.7644 11.4142 7.64396 -16.2258 9.71345 +4826 4 26.1059 19.0334 11.9849 -72.3018 -1.47246 20.779 +4827 6 43.8315 11.1413 18.4425 12.0955 7.77381 31.2403 +4828 4 43.582 10.9955 17.5403 1.6883 -14.8273 -19.2234 +4829 4 44.4878 10.475 18.7348 -4.89818 7.49251 -15.5557 +4830 6 33.4942 40.5585 37.6724 7.87983 -3.11064 16.6213 +4831 4 33.9456 40.2455 38.4765 5.57637 6.44045 -9.71494 +4832 4 32.6057 40.2384 37.8499 -11.5443 1.61602 -9.31227 +4833 6 15.6218 26.7049 39.4143 -33.8245 -53.4627 11.7102 +4834 4 15.4245 26.9754 40.2985 -0.693124 5.44593 20.3253 +4835 4 16.1216 27.3809 39.0562 36.6223 43.7441 -31.7418 +4836 6 4.38199 13.876 40.8778 6.07973 -11.0772 -3.70535 +4837 4 5.33347 13.6897 41.0138 -14.6737 -0.272428 -1.39073 +4838 4 4.02273 13.2235 40.2449 7.64869 11.7946 8.98025 +4839 6 20.1779 10.396 38.2135 -21.4206 4.43784 1.78325 +4840 4 20.3564 10.9148 37.4134 10.9013 -11.3706 0.559506 +4841 4 20.991 10.2443 38.6984 6.99273 1.77474 -1.94206 +4842 6 15.1578 19.2491 23.8705 6.70925 0.197906 -4.49513 +4843 4 15.3523 20.1614 24.134 -1.79925 -4.44488 8.10361 +4844 4 15.0598 19.3463 22.9079 -1.20619 -5.61783 14.9214 +4845 6 47.881 28.6148 15.8048 16.8356 22.7469 11.8397 +4846 4 48.0602 27.74 15.4965 -2.52866 -23.0751 -5.40804 +4847 4 48.6281 28.8091 16.402 -10.5906 -5.01786 -6.93826 +4848 6 29.925 30.905 18.9707 11.7406 3.33263 -1.10353 +4849 4 29.0879 30.4807 18.764 -8.84985 -7.33813 -1.92291 +4850 4 29.807 31.8375 18.7873 -6.04184 4.11832 2.37084 +4851 6 11.9324 35.8064 28.512 -27.4265 24.0258 -21.7564 +4852 4 12.5706 36.1347 29.1334 15.2736 -4.81493 21.8335 +4853 4 12.2236 34.9831 28.145 8.79196 -20.6768 -0.490374 +4854 6 29.967 37.8624 25.4885 4.59009 -4.14727 -0.313094 +4855 4 30.2605 37.0012 25.8228 -4.78695 -0.224547 -14.1967 +4856 4 30.4431 38.4647 26.0537 0.190265 15.5785 7.27405 +4857 6 52.6385 28.1101 32.2696 27.4129 -14.0906 14.429 +4858 4 52.1837 28.8064 31.8018 1.35463 13.918 -3.63194 +4859 4 53.5572 28.4115 32.4361 -8.8806 -0.527566 -10.0859 +4860 6 37.0194 40.0856 11.9811 12.8522 -14.0915 -8.99985 +4861 4 36.2698 40.6335 12.1547 -20.3135 9.86443 5.11387 +4862 4 37.3206 39.8255 12.8594 7.06858 1.59634 4.17732 +4863 6 16.6823 16.7862 36.5016 -40.0159 24.4695 -22.7659 +4864 4 15.9639 17.4464 36.7433 30.1481 -22.6997 -3.51596 +4865 4 16.709 16.8774 35.5181 2.88256 -1.64708 20.873 +4866 6 28.0056 4.17661 38.8341 -15.1907 4.44859 15.1459 +4867 4 28.8664 4.34511 39.2253 10.7528 -1.70638 -4.98709 +4868 4 28.1362 3.72531 37.9969 -2.54795 -6.06729 -7.91519 +4869 6 28.9121 0.2613 17.7196 11.2429 43.6022 -6.13696 +4870 4 28.206 0.913023 17.5432 1.57334 -10.0134 0.986336 +4871 4 28.5175 41.3357 17.883 -22.7122 -29.353 3.51833 +4872 6 22.9275 20.1119 26.272 10.3141 -17.1908 1.54721 +4873 4 23.597 20.0083 26.9758 -6.33812 5.26805 -6.32666 +4874 4 22.343 20.8217 26.5441 4.5912 8.26641 6.04785 +4875 6 49.4104 29.8887 13.4211 -27.0365 40.5227 7.20695 +4876 4 49.0994 30.824 13.2506 14.963 -27.7355 -0.582388 +4877 4 48.6865 29.5209 13.9525 8.18699 -4.12202 2.86767 +4878 6 2.45827 24.8307 7.29137 -22.8365 1.45709 37.207 +4879 4 2.32025 24.5445 8.23446 11.0976 11.5137 -22.649 +4880 4 1.77037 25.516 7.1857 7.09177 -11.7652 -6.70138 +4881 6 30.3948 26.4611 14.3404 -21.8067 20.3233 2.80707 +4882 4 31.1122 26.3224 14.9982 -12.4575 10.0222 -1.69757 +4883 4 29.8137 27.2743 14.5309 34.7851 -33.9666 2.2264 +4884 6 27.0321 32.5068 3.14827 -14.3662 17.1598 1.60641 +4885 4 26.4039 33.1156 3.62616 22.1531 -16.0826 -13.2832 +4886 4 27.3831 31.9163 3.82559 -1.71579 -4.01879 3.19031 +4887 6 34.2634 14.7959 1.27313 2.99828 -7.05923 -10.0889 +4888 4 35.1835 14.4352 1.19997 -20.4533 4.23129 -4.55267 +4889 4 33.713 14.3258 0.588346 24.9828 8.52884 21.9593 +4890 6 30.022 8.54163 1.32868 -10.2939 -13.069 16.6852 +4891 4 30.0052 9.45247 1.0409 -5.08902 11.4157 2.73646 +4892 4 29.2496 8.43498 1.92915 15.9692 5.13326 -10.6744 +4893 6 42.5647 11.5185 27.7103 -4.68909 6.08661 -3.61857 +4894 4 42.216 12.3928 27.8946 9.09127 8.642 -2.18095 +4895 4 41.8714 10.9656 28.0604 -6.00702 -16.6262 4.78299 +4896 6 52.461 39.5492 17.8365 12.2605 -26.0754 -32.0817 +4897 4 51.7553 39.7908 18.3861 -39.7898 9.50592 28.6027 +4898 4 53.1226 40.1801 18.0155 30.5873 23.5517 5.0779 +4899 6 33.2136 4.91918 31.6183 -6.56942 36.6821 16.923 +4900 4 32.9061 5.86322 31.5606 3.78329 -26.1329 5.01225 +4901 4 32.8884 4.48208 30.835 -2.61462 -3.20134 -11.4125 +4902 6 6.2936 16 18.7476 -12.5252 7.31014 22.9936 +4903 4 5.79227 16.5246 19.4216 24.8679 -4.64947 -16.2991 +4904 4 5.64136 15.3462 18.514 -6.08951 -9.62478 -9.34051 +4905 6 8.52033 14.5365 24.6875 -9.84601 3.26611 -2.01077 +4906 4 9.36791 14.3624 25.0978 6.86066 0.30113 1.47813 +4907 4 8.18366 13.6846 24.3866 1.77672 -1.96336 3.84573 +4908 6 22.6911 10.1297 32.1351 -27.5214 -52.5729 10.3709 +4909 4 22.3884 10.9899 32.3649 2.47289 32.4289 -2.22619 +4910 4 23.5203 10.1223 31.6812 20.4751 21.0076 -14.9216 +4911 6 11.292 2.12704 14.679 -26.9964 -14.1635 0.457424 +4912 4 10.3004 2.01295 14.5746 25.662 7.6895 -7.09692 +4913 4 11.7079 2.38272 13.8392 -0.157448 -3.91762 -7.39795 +4914 6 44.9096 15.591 36.2717 33.6405 -1.91298 -30.8875 +4915 4 45.0764 15.4828 35.303 -3.33411 7.1012 27.4883 +4916 4 43.99 15.446 36.3379 -31.2371 -2.78707 10.2167 +4917 6 9.72465 19.0179 31.2227 19.6005 -24.8416 -16.8371 +4918 4 10.5897 19.4265 31.3159 1.30764 -1.40065 3.11778 +4919 4 9.11252 19.5759 31.653 -23.8989 17.913 16.8503 +4920 6 51.9714 7.58847 16.6881 21.0297 -20.8952 -55.8985 +4921 4 52.6598 6.90966 16.567 -10.1825 8.15334 22.1112 +4922 4 51.6538 7.5728 15.7392 -8.87714 21.5211 34.751 +4923 6 31.4317 34.7753 36.422 -0.942044 -9.40807 -31.2122 +4924 4 31.7249 34.7672 37.3268 6.30465 10.9632 14.3566 +4925 4 31.2441 35.6593 36.0754 6.17504 10.5044 11.3925 +4926 6 4.22663 15.0937 15.3657 -12.9272 -11.1361 22.285 +4927 4 4.10058 14.8824 16.3208 1.18356 5.05287 -17.269 +4928 4 5.17453 15.1773 15.2713 12.4851 5.61025 -4.39011 +4929 6 47.7531 20.6767 28.0224 11.2198 -3.02063 -12.9376 +4930 4 47.6925 19.771 27.6598 -2.10862 13.919 9.51432 +4931 4 48.3916 21.1163 27.4231 -12.1395 -0.81062 10.3277 +4932 6 15.815 1.15165 24.4078 -58.142 17.9603 -16.0616 +4933 4 15.2825 0.557615 24.9446 12.6892 -15.3828 1.22604 +4934 4 15.0545 1.63036 23.9524 41.7436 -8.72437 9.7488 +4935 6 34.5811 39.7067 40.0776 25.1973 35.6425 -42.1699 +4936 4 34.2041 40.3093 40.7031 -18.6223 -6.05265 24.4589 +4937 4 34.3171 38.8242 40.1905 -21.7766 -38.3424 16.3885 +4938 6 20.1959 32.1778 34.4064 -21.1308 28.8301 22.4919 +4939 4 19.7756 32.8897 35.0113 13.9702 -37.934 -23.8567 +4940 4 21.1121 32.1056 34.6926 -2.59197 2.17732 9.39736 +4941 6 19.2966 38.5284 11.8437 26.0429 16.0259 -0.414132 +4942 4 19.2747 37.5954 11.9891 -3.91225 -17.7096 3.53088 +4943 4 20.0654 38.8356 12.3915 -17.5462 -2.40166 -9.14392 +4944 6 6.53181 13.5016 26.8314 -26.032 48.4544 -13.2533 +4945 4 5.96734 14.0602 26.204 31.1233 -23.713 24.7575 +4946 4 6.50803 12.6321 26.4707 -0.853216 -24.803 -10.5103 +4947 6 23.5899 31.5666 33.3383 5.98922 -6.50638 -9.93577 +4948 4 23.0479 31.6137 34.1308 1.15429 -4.79335 1.92272 +4949 4 23.6428 30.629 33.0606 -7.31668 7.17491 0.194963 +4950 6 41.0566 31.9249 16.2102 56.5158 -30.8904 -22.4873 +4951 4 41.9283 32.0344 16.659 -25.525 5.07155 -0.752829 +4952 4 41.3339 31.2779 15.4895 -19.0587 21.5349 12.1439 +4953 6 31.7523 18.8667 19.3593 3.35741 25.414 0.712525 +4954 4 32.0759 19.7269 19.7383 -8.81617 -22.0304 -12.3923 +4955 4 31.2718 18.4298 20.0739 7.05067 -2.94537 3.38628 +4956 6 10.4941 4.11052 19.3414 6.42456 29.4713 -33.6332 +4957 4 9.72315 4.57262 18.9428 7.32966 -14.5804 7.11 +4958 4 11.2095 4.33965 18.6811 -15.5987 -11.1936 33.5314 +4959 6 1.36933 32.4682 19.2841 21.0988 -14.4161 24.2075 +4960 4 2.01529 31.7231 19.2122 -13.2253 9.85044 -10.2965 +4961 4 1.01532 32.721 18.4367 5.36339 -4.1954 -20.4987 +4962 6 42.8687 16.8583 24.9978 45.6636 -43.4462 -50.5941 +4963 4 42.5079 17.7172 24.9824 -17.3855 32.283 0.331695 +4964 4 43.4322 16.7911 24.1362 -30.0172 8.55702 44.8961 +4965 6 45.317 19.181 4.10785 3.8422 34.8536 -4.15721 +4966 4 46.019 19.8398 3.89275 -2.03222 -14.2005 10.5278 +4967 4 44.6424 19.7199 4.5744 3.59127 -10.0852 -3.22755 +4968 6 29.1417 19.8939 35.7514 6.11075 -32.58 -16.2332 +4969 4 28.6926 20.3067 36.4515 -23.9686 13.1333 31.3988 +4970 4 29.2427 20.5957 35.1143 7.28783 5.32225 -12.4577 +4971 6 31.9564 21.8498 19.6592 2.82401 14.2352 -0.350828 +4972 4 32.7548 21.9543 19.0677 -31.5105 -7.28354 24.2009 +4973 4 31.6217 22.7614 19.848 10.5207 -20.3739 -6.13763 +4974 6 39.1981 8.2717 18.8284 -32.9061 14.1933 0.428726 +4975 4 38.9624 7.35629 18.6463 1.07118 -6.83808 -1.96228 +4976 4 38.3348 8.76709 18.6863 31.0345 -14.9445 1.78619 +4977 6 33.2818 13.2775 41.2684 -13.2208 -33.3764 1.31987 +4978 4 32.393 13.5626 41.0006 -3.83673 2.91025 7.56978 +4979 4 33.1808 12.3338 41.5845 5.22215 22.8712 -2.04361 +4980 6 5.9413 29.5498 35.797 -32.456 -34.3071 -6.72563 +4981 4 6.35963 30.284 36.1739 22.861 33.0715 10.0739 +4982 4 6.49565 29.1835 35.1072 8.32337 2.91553 -5.44074 +4983 6 13.0321 34.2086 31.915 -24.835 -40.2345 36.8573 +4984 4 13.0272 33.4084 31.376 1.88868 -0.760633 -7.07942 +4985 4 12.5489 33.9041 32.737 18.271 18.5714 -18.1292 +4986 6 33.9591 21.7903 18.011 18.8454 -21.734 -8.71067 +4987 4 34.7458 21.1933 18.012 -16.5142 3.18134 2.17277 +4988 4 34.2934 22.6573 17.8484 16.983 20.6817 -10.003 +4989 6 35.9748 41.3385 18.1559 -11.3515 0.0380054 -35.3696 +4990 4 35.8093 41.5204 17.1769 9.12346 -12.4659 34.6458 +4991 4 36.6045 0.098617 18.3947 7.40652 10.177 5.52403 +4992 6 34.8515 37.6574 30.5934 11.7527 -35.7483 27.3047 +4993 4 35.1492 36.8608 30.1169 2.57906 15.2804 -10.7791 +4994 4 34.9371 37.33 31.5271 -8.43612 19.6249 -16.9201 +4995 6 26.002 34.4146 4.67279 -8.48904 3.78898 9.19231 +4996 4 25.4415 34.5852 5.42871 -16.9308 -4.98482 2.97274 +4997 4 26.7915 34.86 4.9592 18.7282 4.65341 -5.76761 +4998 6 19.0552 33.5605 1.32358 6.49267 31.5074 -37.6332 +4999 4 19.8139 33.1288 1.70335 8.38847 -12.1483 9.88993 +5000 4 19.4402 34.1326 0.589952 -11.7405 -21.1797 25.0755 +5001 6 25.2648 8.23393 8.59155 9.31521 -3.65292 19.8467 +5002 4 25.4875 8.13778 9.5404 -3.07709 1.08931 -10.3145 +5003 4 25.4314 9.16241 8.38927 -1.28134 -0.00667841 -6.07783 +5004 6 12.8479 19.6935 13.0483 24.3757 5.37981 -4.8091 +5005 4 11.9603 19.9957 12.9501 -28.6845 1.86907 1.18076 +5006 4 13.3523 20.516 12.8959 -4.89806 -16.374 -0.906345 +5007 6 53.3502 11.4299 5.80806 17.1624 -7.42289 17.7098 +5008 4 53.8461 12.0471 6.36061 9.49207 -4.93163 0.0376 +5009 4 52.6392 11.9481 5.49246 -25.6427 10.4986 -14.7278 +5010 6 9.84876 16.0411 31.2026 18.9205 20.8399 7.27663 +5011 4 9.06508 15.7062 30.7868 -18.8641 -2.54228 -13.3824 +5012 4 9.84527 17.0253 31.1624 -7.05614 -14.0763 0.861631 +5013 6 25.427 20.2931 3.30062 11.4464 23.222 26.9187 +5014 4 25.5454 20.7694 4.15249 -9.33169 -17.4988 -10.5652 +5015 4 25.6323 21.0333 2.7154 -3.32412 -15.1122 -12.6987 +5016 6 20.7611 8.20749 15.6389 12.285 -44.7943 -30.6071 +5017 4 20.4521 8.55687 16.4556 -20.4937 3.03897 24.5457 +5018 4 20.4185 7.27697 15.5079 3.31214 29.403 13.2982 +5019 6 37.6491 8.60321 9.97383 13.4411 2.14626 39.4708 +5020 4 37.9762 7.71523 10.2023 -7.3296 7.95364 -3.74733 +5021 4 37.281 8.55077 9.10696 -2.37522 -5.79058 -16.8845 +5022 6 50.6587 4.51935 24.2622 -13.5896 -19.0591 8.29097 +5023 4 49.9232 3.87067 24.2726 8.09814 12.5004 -4.89174 +5024 4 51.4381 3.99879 24.4754 4.23299 2.4676 7.18675 +5025 6 20.1738 24.8175 34.9087 -20.6162 39.8894 -22.5586 +5026 4 19.8889 25.4664 34.1955 11.6566 -19.5752 19.2833 +5027 4 20.4138 24.0094 34.4666 -0.241841 -16.354 -5.00311 +5028 6 30.5812 22.5243 11.2258 -36.8716 21.596 38.6978 +5029 4 31.1688 21.9929 10.7494 35.9784 -15.9007 -22.5785 +5030 4 31.0799 23.2498 11.6175 0.71333 3.79074 -7.65826 +5031 6 17.3246 40.781 8.03002 -31.7256 21.6985 11.3561 +5032 4 17.3609 40.073 8.69249 8.70624 -3.14378 -12.3263 +5033 4 18.1517 40.9293 7.58873 21.0517 -16.9909 -7.06703 +5034 6 23.9551 41.0422 26.0635 49.9815 4.82526 35.6353 +5035 4 24.3667 40.5978 25.3173 -4.54613 -3.84774 -13.2149 +5036 4 23.0402 41.1884 25.9461 -38.539 -4.36769 -14.447 +5037 6 9.79432 25.5848 27.2203 6.65484 -20.1236 -27.319 +5038 4 10.0774 24.9678 26.4912 -4.54744 21.2611 22.5851 +5039 4 10.2742 25.3181 28.0139 -2.97183 -5.43805 2.20583 +5040 6 35.2559 29.8148 24.7567 4.66903 26.9266 -5.93859 +5041 4 34.3843 29.755 24.359 -8.51564 -12.4096 -2.57191 +5042 4 35.4992 30.7322 24.5163 3.09853 -9.53322 8.65044 +5043 6 2.14554 4.24448 10.5593 -22.2482 14.7122 10.1934 +5044 4 1.71214 4.34677 11.4486 21.0071 -10.277 -13.7719 +5045 4 1.55235 4.73342 9.96914 3.10164 -3.012 2.95666 +5046 6 43.1737 3.93442 23.504 -19.8173 -22.9925 0.828755 +5047 4 43.8868 4.03822 22.8829 13.7397 8.75634 -8.56433 +5048 4 42.5624 3.30318 23.0634 7.12322 11.7882 3.68849 +5049 6 18.8936 22.6308 2.43475 37.4693 -11.6119 5.39147 +5050 4 19.8359 22.2985 2.41568 -31.8063 3.38645 -2.45846 +5051 4 18.7431 22.7947 3.37318 -4.67781 1.83629 -1.28906 +5052 6 20.5039 18.9394 41.5502 -45.0653 -1.00263 50.2155 +5053 4 20.0478 18.6838 0.506021 30.3651 -1.16827 -32.2456 +5054 4 19.9073 19.6506 41.2865 12.7012 -1.26976 -15.3796 +5055 6 26.407 7.54687 29.1121 1.4357 2.47637 1.41449 +5056 4 25.6724 7.10479 28.6297 19.9382 8.96422 9.98625 +5057 4 27.0918 7.77745 28.4582 -11.2115 -7.41118 6.83701 +5058 6 25.6474 35.5684 33.7551 28.3954 -27.4775 -24.9773 +5059 4 26.3573 36.1942 33.5448 -9.56627 7.56335 10.8035 +5060 4 25.9974 34.7724 33.2466 -29.6941 19.0168 23.1671 +5061 6 24.829 0.49304 8.41898 49.9168 25.8876 59 +5062 4 25.5758 0.370102 9.1289 -47.1903 5.46774 -40.7742 +5063 4 24.7798 41.5674 8.0141 -4.73142 -31.3088 -22.2887 +5064 6 17.0191 17.3177 3.44507 -46.3903 19.7373 51.2207 +5065 4 16.2469 17.9517 3.64762 33.8447 -23.651 -21.8207 +5066 4 17.1185 16.9245 4.35427 5.98982 5.76213 -27.3591 +5067 6 40.1787 32.0965 19.3495 -2.04197 44.459 1.39821 +5068 4 39.7315 31.3261 19.6693 2.08081 -28.8107 0.337304 +5069 4 40.9568 31.869 18.8472 6.84111 -19.9226 -1.15348 +5070 6 23.382 26.6945 6.30636 26.5913 52.1271 15.5788 +5071 4 24.0556 27.4456 6.44648 -17.1373 -33.2326 -1.34025 +5072 4 22.7142 27.1153 5.75328 -6.08389 -4.52619 -7.61988 +5073 6 28.6524 28.5085 1.41248 40.8971 -13.4399 -11.1281 +5074 4 28.8916 29.4207 1.30452 -22.1266 20.7664 -4.28256 +5075 4 29.5558 28.1704 1.18501 -32.1523 -8.03877 13.3744 +5076 6 12.0456 6.33448 14.0345 -15.8903 -34.4 -29.7535 +5077 4 11.2902 6.05291 13.4483 16.0844 18.9407 21.6686 +5078 4 12.7823 5.99392 13.4906 5.33453 16.7776 14.1371 +5079 6 20.1258 33.7078 32.0959 -18.1893 1.56867 -4.93457 +5080 4 20.1945 33.0222 32.7471 -6.29187 -8.74149 18.477 +5081 4 21.0272 33.8529 31.8657 20.6776 7.89431 -10.0095 +5082 6 12.0665 33.3691 34.5458 -17.2285 -56.0193 -22.1145 +5083 4 11.5086 33.8793 35.1106 -7.76206 16.4549 16.9315 +5084 4 11.5605 32.4987 34.4127 27.4292 33.0374 0.608769 +5085 6 6.00658 22.2666 25.0532 -19.3255 -5.39958 94.237 +5086 4 5.834 22.4197 24.1868 -9.01045 11.6196 -89.8037 +5087 4 5.17345 22.6031 25.4913 31.6285 -9.76338 -3.83253 +5088 6 28.8848 9.49767 11.035 16.7623 9.63116 22.4077 +5089 4 29.0495 10.2086 11.6768 10.1151 -22.3542 -11.392 +5090 4 28.083 9.83925 10.6889 -25.6685 -5.48517 -25.0151 +5091 6 25.9808 31.1499 24.8669 6.22835 -24.9986 7.12483 +5092 4 26.2942 31.9621 24.5011 4.31737 18.7644 -10.9339 +5093 4 26.6597 30.4768 24.6157 -18.0541 8.02771 8.13926 +5094 6 17.4051 22.6403 26.9653 -7.75883 36.9734 2.0054 +5095 4 17.2144 23.5004 27.4753 3.96627 -41.4428 -18.3441 +5096 4 17.5261 21.9375 27.6083 1.93016 -8.19761 6.25563 +5097 6 30.9714 17.6252 1.64088 21.0154 14.9482 37.3685 +5098 4 30.2059 17.6112 1.0839 -20.4324 5.80492 -14.3468 +5099 4 30.9516 18.4373 2.23396 3.22156 -25.7853 -22.8165 +5100 6 35.2764 9.72503 11.2414 -18.3895 -2.76749 -51.624 +5101 4 34.6551 9.56245 10.4589 20.7383 2.80865 37.1903 +5102 4 36.1302 9.43155 10.8742 2.68762 -2.05229 10.7544 +5103 6 12.0172 10.802 4.27563 -38.9121 -6.07101 -4.90761 +5104 4 11.4313 10.6374 5.04504 13.8247 1.49432 -7.40831 +5105 4 11.4074 10.5604 3.53263 22.811 5.33779 9.30002 +5106 6 52.9577 23.1313 7.67787 -9.3269 3.09364 -7.79077 +5107 4 53.8153 23.0871 7.22609 1.51949 2.98805 -1.25247 +5108 4 52.6879 24.0607 7.78743 10.5919 -6.87524 0.0783357 +5109 6 27.3762 5.80009 23.1013 37.771 37.8703 25.2466 +5110 4 28.2178 5.56094 23.5856 -32.2451 -1.57897 -13.9899 +5111 4 27.4704 6.79781 23.0764 -15.1432 -38.3322 -6.34326 +5112 6 22.7771 37.7063 15.5287 -6.89324 -10.2053 44.7861 +5113 4 22.8198 37.7465 14.5962 3.81902 5.91484 -35.4551 +5114 4 23.2903 36.9427 15.8415 -1.83068 2.7653 -4.67104 +5115 6 30.583 30.1381 39.7472 11.9278 5.78959 4.89923 +5116 4 30.1399 29.6129 39.0656 -4.27402 4.25284 -2.63349 +5117 4 30.6547 31.067 39.4612 -8.3831 -13.7724 -7.9353 +5118 6 26.5154 14.8633 29.9609 11.0831 -12.5589 -33.9006 +5119 4 25.6935 15.2477 30.2118 -18.1143 15.4408 19.147 +5120 4 27.1376 14.9035 30.6723 6.99544 5.71887 23.1856 +5121 6 9.52617 19.5446 37.4141 -27.8096 33.0225 -3.94279 +5122 4 8.56344 19.6819 37.5998 22.5694 -19.9005 4.13551 +5123 4 9.71087 20.3892 36.9619 8.68778 -16.8671 10.038 +5124 6 0.93064 14.8656 2.69338 -45.7679 -11.5139 71.6593 +5125 4 1.44105 15.217 2.01526 37.3122 25.2366 -40.5783 +5126 4 0.982855 15.4275 3.5214 11.2099 -15.0526 -29.9277 +5127 6 46.4291 27.1302 41.5927 44.8021 -5.11347 -18.4756 +5128 4 47.4269 27.1857 41.3316 -52.8753 -1.56841 10.8767 +5129 4 46.0453 26.5632 40.9031 3.09365 7.20255 7.14326 +5130 6 47.6703 23.0461 21.3817 14.1329 62.5249 18.4178 +5131 4 46.9615 23.2467 20.7836 -14.1781 -2.67912 -10.5965 +5132 4 47.8255 22.1376 21.4096 0.736735 -54.6337 -3.62162 +5133 6 39.861 22.2186 3.09273 14.3751 -13.6386 -17.8056 +5134 4 38.9812 22.2192 3.47284 -7.54245 -0.786418 6.90323 +5135 4 40.0217 21.2868 2.78929 -10.5756 29.8648 14.1337 +5136 6 14.9857 14.9315 33.4628 8.45923 30.4043 17.83 +5137 4 15.3946 15.8263 33.6275 -11.7248 -28.7506 -9.93609 +5138 4 14.5839 14.7058 34.318 1.67348 -1.86342 -8.89677 +5139 6 27.3225 11.4951 31.9326 -53.5602 -46.3542 13.457 +5140 4 26.8632 12.0627 32.5566 10.8872 8.4751 3.08438 +5141 4 28.1269 11.8297 31.6518 53.6341 36.944 -15.9306 +5142 6 36.7606 7.97817 7.63938 -5.6216 -14.483 -15.6739 +5143 4 35.961 7.43887 7.80711 8.78578 3.79539 -7.6162 +5144 4 37.414 7.37034 7.2323 -6.45073 3.96969 3.37374 +5145 6 49.4351 9.64395 18.2091 29.626 55.2849 10.866 +5146 4 50.1121 10.1978 17.7651 -9.80365 -29.4086 -13.348 +5147 4 49.2806 10.2909 18.9191 -22.4891 -21.6225 2.73598 +5148 6 27.0558 33.8708 10.7695 -35.2964 21.4972 9.63291 +5149 4 27.0077 33.3399 10.0051 13.5655 -23.8621 -34.587 +5150 4 26.1863 34.3133 10.6733 10.9844 1.63438 18.9088 +5151 6 11.1931 37.467 6.82672 4.88099 -16.6436 19.1561 +5152 4 10.8369 38.341 6.72067 -6.30082 13.8936 -5.38019 +5153 4 12.1372 37.6177 6.93955 5.33816 -5.06614 -4.03667 +5154 6 19.2682 19.4041 21.904 -23.2853 8.1035 46.9014 +5155 4 18.5523 19.4276 21.2977 -21.2798 -5.04156 -20.5384 +5156 4 20.0545 19.4439 21.4012 35.6905 -5.22778 -21.4405 +5157 6 54.5004 2.91828 22.5705 32.5661 -1.01917 48.733 +5158 4 54.2618 3.02388 21.6728 -2.16971 10.501 -40.9175 +5159 4 0.435524 3.25313 22.7695 -30.9494 -6.38648 -13.13 +5160 6 45.0599 10.868 24.2364 14.5135 -18.2796 4.13426 +5161 4 44.3635 11.4663 23.9664 0.226806 13.7258 12.1538 +5162 4 45.5813 11.1999 25.0017 -10.9868 0.331296 -15.4884 +5163 6 14.3917 34.4176 24.7766 -9.76404 -18.453 -6.38428 +5164 4 14.7761 35.2693 24.9957 4.99605 2.44674 1.2141 +5165 4 14.8449 34.0832 23.9904 0.575187 7.45256 -7.27956 +5166 6 50.5869 17.5623 4.30497 19.1488 -58.6727 24.3661 +5167 4 51.3501 17.8958 4.78847 0.670503 12.5806 -1.04554 +5168 4 50.1422 18.2474 3.88142 -19.7161 48.0777 -23.3625 +5169 6 14.9242 33.337 34.1076 -18.6172 33.5363 80.554 +5170 4 15.0808 32.9083 33.3321 11.226 -38.5345 -73.3592 +5171 4 14.0723 33.0217 34.4665 7.96171 10.4343 -9.42002 +5172 6 20.8631 33.5747 38.9135 21.2953 11.2024 -25.7312 +5173 4 20.865 34.0752 39.7143 -3.94121 7.45437 24.6588 +5174 4 20.36 32.7884 39.0656 -12.436 -21.6406 1.81461 +5175 6 7.7707 4.74963 26.7362 26.5342 -10.6541 19.1955 +5176 4 7.23261 4.91898 27.5026 -6.83786 10.9421 8.37469 +5177 4 7.15089 4.73593 26.0203 -3.95236 1.60233 -15.9617 +5178 6 9.2875 21.4887 22.2941 45.0197 -19.5209 20.7118 +5179 4 8.6739 21.9912 21.7696 -4.21454 15.1903 -23.2464 +5180 4 10.2572 21.6206 22.0058 -46.5259 5.6334 -2.177 +5181 6 20.5439 38.2154 8.85856 -11.8412 3.64647 49.7312 +5182 4 20.3505 38.5634 9.79035 9.75602 -4.66312 -40.2998 +5183 4 20.2844 37.2891 8.95048 10.2824 2.6457 -7.05014 +5184 6 30.1005 39.0839 30.7484 -12.1958 38.1552 23.9792 +5185 4 30.3724 39.9578 31.2326 -12.541 -45.9124 -25.2432 +5186 4 29.1103 39.003 30.8437 30.6219 6.07536 -1.13857 +5187 6 16.0462 22.036 24.5064 2.37861 -9.55962 -5.99251 +5188 4 16.6334 21.9741 23.7207 6.17482 7.89117 19.2285 +5189 4 16.5569 22.3155 25.2979 1.4399 -2.17025 -8.02685 +5190 6 5.74172 29.2061 14.4603 -14.7312 11.1013 -1.58992 +5191 4 6.41865 28.6839 14.8489 24.8954 -16.4528 0.429681 +5192 4 5.37542 29.618 15.2515 -13.4536 5.99623 -6.25212 +5193 6 28.0689 3.08071 25.2267 -3.20814 35.3244 14.901 +5194 4 28.6407 3.76435 24.8336 -2.36389 -14.401 -4.10269 +5195 4 27.6795 3.6106 25.9691 7.41152 -23.0621 -10.2478 +5196 6 45.9381 29.3111 31.4283 -35.5447 25.9568 9.82539 +5197 4 45.677 28.707 30.7493 2.31008 -18.1922 -21.3643 +5198 4 45.1265 29.9079 31.4744 34.4717 -15.8255 11.1052 +5199 6 11.2229 22.8376 36.7897 -1.27591 2.9175 -5.69903 +5200 4 10.6623 23.4314 36.25 10.4728 -5.78036 -0.0474996 +5201 4 12.0147 22.5841 36.2713 -9.37786 4.28983 5.66853 +5202 6 18.9444 40.1485 39.92 -15.471 -8.01044 2.33142 +5203 4 19.1439 39.1941 39.9507 -1.34087 5.25319 4.4419 +5204 4 18.8847 40.4877 40.8271 3.43659 -8.21326 1.76593 +5205 6 23.5503 26.0803 21.2869 1.98517 -8.46863 16.2364 +5206 4 22.847 26.649 20.9475 -0.393515 -5.32061 4.06564 +5207 4 23.2913 25.6403 22.1336 -2.29953 13.2014 -21.5927 +5208 6 16.8518 5.38834 15.8565 -25.8193 5.07215 -6.0744 +5209 4 16.3979 5.3834 15.0179 8.08064 -16.6857 -11.3384 +5210 4 16.3642 6.13153 16.2159 17.5374 8.90145 23.838 +5211 6 12.0293 26.6115 15.0052 48.8575 28.3431 -20.5386 +5212 4 11.753 25.9113 15.557 -22.1508 -25.2102 16.954 +5213 4 11.3677 26.9943 14.4309 -20.7091 -9.23994 -0.184726 +5214 6 14.3404 41.4231 2.37222 21.8802 31.2536 -15.2067 +5215 4 13.6639 41.0433 2.88545 -29.1815 -25.4177 23.2655 +5216 4 14.3137 0.446574 2.65591 6.04323 -12.5169 -2.89291 +5217 6 50.3994 35.8721 9.32148 7.74023 -5.00078 -0.0244409 +5218 4 50.7985 35.7097 8.44539 1.7624 12.9821 5.72804 +5219 4 50.9327 36.5364 9.8137 -9.76519 -8.88391 -14.7497 +5220 6 11.3732 22.6657 26.8674 13.5542 4.36995 9.37334 +5221 4 12.2226 22.4007 26.49 -3.86507 -2.48494 3.34128 +5222 4 10.7274 22.4174 26.2153 -14.8849 -5.84603 -9.40936 +5223 6 8.44501 34.5567 21.2657 -4.1178 -59.9386 7.63204 +5224 4 8.06567 35.1301 21.9247 -8.42944 2.78434 16.8569 +5225 4 8.10966 33.58 21.4462 13.1168 58.8803 -11.2866 +5226 6 9.4289 8.66253 24.4817 -31.3326 14.2813 -20.5935 +5227 4 8.45611 8.64572 24.2655 24.8039 10.7682 6.42659 +5228 4 9.52915 9.21836 25.2644 -0.461641 7.68001 5.20174 +5229 6 32.603 22.3274 34.5057 1.1064 -2.38466 -37.2003 +5230 4 32.4525 23.1707 34.0368 4.85154 -2.46017 7.68642 +5231 4 32.8396 22.5701 35.3818 7.58742 14.9461 32.9529 +5232 6 26.736 26.1837 7.12165 10.4716 16.8024 -17.1295 +5233 4 25.9537 25.8031 7.51207 -7.84415 -15.2109 12.7352 +5234 4 26.4604 27.1054 6.93432 8.77765 -19.2484 4.4957 +5235 6 34.0014 11.9295 3.96807 -3.56186 4.82634 5.33773 +5236 4 33.6494 11.5631 4.78494 7.3544 2.33703 4.85457 +5237 4 33.8594 12.8842 4.06904 0.478869 -2.08104 -5.13073 +5238 6 21.473 20.924 37.1992 5.8677 19.4674 12.3893 +5239 4 22.3242 21.3752 37.157 2.6693 1.87465 3.04951 +5240 4 21.708 20.0203 37.0255 -6.20277 -25.1527 -1.47337 +5241 6 18.4792 41.0219 0.672743 -35.2491 -25.3697 -26.4792 +5242 4 17.5363 41.1592 0.451811 6.2729 -6.09178 6.10687 +5243 4 18.7532 41.8934 0.847545 18.5165 37.9853 8.81983 +5244 6 41.3458 41.7141 25.1818 17.8335 14.8146 -1.57438 +5245 4 40.8444 40.9381 25.3951 -6.7286 -20.9895 5.67055 +5246 4 41.5773 41.6158 24.2546 -2.61686 2.51709 -2.2804 +5247 6 27.6337 28.128 3.93443 68.2433 49.922 -72.4808 +5248 4 27.747 28.0641 2.90056 -5.60951 6.59214 55.905 +5249 4 26.974 27.5707 4.19301 -60.7891 -51.6503 16.466 +5250 6 18.2766 10.5218 31.4985 31.6557 -13.945 -4.11948 +5251 4 17.4661 10.038 31.5755 -21.8827 2.32902 1.26527 +5252 4 18.1351 11.463 31.4681 -8.30794 8.79106 3.21692 +5253 6 11.3047 37.9513 14.7719 14.2766 22.5792 8.51892 +5254 4 10.8196 37.2524 14.3384 -3.55752 -10.2024 4.33151 +5255 4 11.8722 37.607 15.4977 -19.1201 -2.12261 -16.4117 +5256 6 0.810718 18.1323 27.5767 30.9572 19.3393 -0.702274 +5257 4 0.190255 17.4711 27.3024 -13.6082 -17.9307 4.12615 +5258 4 1.6652 17.6816 27.7433 -15.3641 2.36995 -0.952151 +5259 6 36.7957 10.7342 20.2882 16.9593 17.0847 7.18326 +5260 4 36.2525 10.0089 20.0111 -13.8544 -11.0907 -5.31633 +5261 4 36.5766 10.8708 21.2175 -0.466777 -2.92115 4.06643 +5262 6 47.4269 25.5204 8.035 -8.77625 7.04012 -26.0141 +5263 4 47.2351 25.672 7.07342 16.0738 -5.10236 26.6147 +5264 4 46.6031 25.1946 8.38488 -7.38433 -0.0309169 8.21918 +5265 6 13.9121 35.1279 15.9963 57.6206 21.904 15.8158 +5266 4 13.18 34.6338 16.2776 -41.6081 -30.4219 4.97616 +5267 4 13.8612 35.4714 15.1124 -11.7278 3.29634 -19.5683 +5268 6 29.56 35.3617 16.1847 -46.2751 8.28104 -14.7299 +5269 4 30.2098 34.9035 16.6971 16.3841 -9.08849 15.1595 +5270 4 28.6495 34.9755 16.3324 34.0842 8.73794 -6.93478 +5271 6 29.4892 25.8842 32.4194 -24.256 -10.4352 -29.1805 +5272 4 28.8256 25.7516 33.0892 -1.91161 2.59937 23.0953 +5273 4 29.0388 25.4531 31.6468 24.6149 5.96309 7.68736 +5274 6 24.1242 2.12171 25.4449 33.2745 25.8541 -21.7468 +5275 4 24.4973 2.84525 24.8288 -6.14236 -31.0627 26.9036 +5276 4 24.7925 1.39916 25.5361 -16.9688 12.032 -10.1501 +5277 6 4.54733 34.4389 19.1463 -35.302 -7.10976 -3.39284 +5278 4 4.35486 34.5879 18.2161 16.9971 0.874352 -7.12679 +5279 4 3.63202 34.4395 19.5005 25.743 -3.14875 11.9651 +5280 6 10.1206 17.2361 14.3164 8.36708 -29.6599 -28.3251 +5281 4 10.306 17.5039 15.1955 -0.106022 16.7729 24.4966 +5282 4 9.5035 17.8022 13.8616 -7.59249 10.3925 2.01091 +5283 6 21.4437 41.7724 34.6698 -12.6382 -8.67476 11.1219 +5284 4 21.3209 41.1297 35.367 19.1323 -10.7035 11.8578 +5285 4 20.52 0.052046 34.4982 -0.738196 4.11389 -17.598 +5286 6 36.1618 24.1149 12.6039 -38.5184 -29.276 -18.6614 +5287 4 35.5274 23.7914 13.2897 25.4622 4.78071 -2.2183 +5288 4 35.751 23.7447 11.7708 17.6549 15.9976 15.8112 +5289 6 49.5813 18.6026 19.9424 19.3655 4.31785 -3.79274 +5290 4 50.05 19.3681 19.5461 -11.4841 -9.87428 2.01803 +5291 4 50.2881 17.9408 20.0283 -8.44417 3.53865 1.64593 +5292 6 1.24663 7.05846 14.4912 39.2605 -25.8072 -27.0237 +5293 4 1.83321 6.85564 13.6734 -27.5618 7.792 37.3713 +5294 4 1.40902 6.33035 15.1313 0.69425 14.6008 -10.3474 +5295 6 12.7431 22.7725 31.2519 -28.0711 -22.2846 -24.537 +5296 4 12.731 22.0484 30.5842 -1.03989 14.4355 17.1556 +5297 4 13.6361 23.0601 31.2889 29.0982 7.61123 0.941905 +5298 6 8.17623 18.6217 27.8167 28.4831 -7.95646 -20.137 +5299 4 8.40342 17.6669 27.8028 -7.19499 14.8132 8.92302 +5300 4 8.90402 18.9943 27.2753 -13.5351 -1.9306 8.34595 +5301 6 52.1398 28.0368 15.3061 -5.99984 -2.63203 -6.56281 +5302 4 52.212 27.4921 14.5152 3.50742 -7.1981 5.43712 +5303 4 52.1344 28.9249 14.9274 -1.52971 -5.17654 6.68842 +5304 6 52.6974 21.8977 10.081 -19.9085 6.90605 5.3514 +5305 4 53.3388 22.3376 10.626 19.2735 6.64212 5.60719 +5306 4 52.8023 22.3165 9.21858 0.448532 -1.39229 -3.54893 +5307 6 22.3312 5.79987 2.67028 14.2956 -6.96789 22.7666 +5308 4 22.4342 5.66665 3.62826 -7.95027 2.50856 -4.24886 +5309 4 22.7763 5.02131 2.34757 -2.68692 -18.1597 -17.0707 +5310 6 15.4178 16.2178 21.8878 29.1139 16.3559 -34.9346 +5311 4 14.4763 16.1482 22.0206 -17.0561 3.51129 1.66656 +5312 4 15.5967 16.6295 20.979 -16.1676 -12.6325 35.129 +5313 6 28.6996 41.2944 33.8986 -0.299799 0.972013 4.01662 +5314 4 28.6528 40.5712 34.5346 5.69191 -6.81028 -1.89437 +5315 4 27.7925 41.4039 33.5788 7.00998 2.71453 4.16387 +5316 6 9.0271 31.2603 18.2166 -24.0632 3.5617 9.69965 +5317 4 9.00312 32.2249 18.3215 -0.833429 -0.795431 1.49639 +5318 4 8.39564 30.8695 18.8792 23.5138 4.17381 -14.686 +5319 6 20.5401 20.4009 18.1765 -9.82111 13.5354 -7.0052 +5320 4 21.0961 20.6619 18.9088 6.00228 -1.57494 14.3732 +5321 4 19.8969 21.1451 18.1138 9.42471 -20.4088 -2.28899 +5322 6 53.9632 14.7108 37.8185 38.9936 -13.777 37.4998 +5323 4 53.5065 15.4999 38.0588 -19.2143 21.2037 -5.62994 +5324 4 53.6553 14.2856 37.0504 -18.643 -5.89619 -29.3657 +5325 6 28.9005 15.3805 18.8553 43.4355 2.75939 -10.7082 +5326 4 29.8744 15.2601 18.5577 -43.1698 -4.30042 15.6378 +5327 4 28.8821 15.3937 19.8257 1.95554 -2.72042 -0.550014 +5328 6 2.00757 25.8231 18.9102 1.56834 13.1457 16.4238 +5329 4 2.16994 26.6099 18.3718 5.10623 3.14141 1.15535 +5330 4 1.76535 25.1325 18.3092 -5.75322 -15.1157 -18.9078 +5331 6 53.2586 40.7003 24.294 -3.95682 23.2035 5.10337 +5332 4 53.3627 39.7881 24.0333 10.577 -13.1769 -1.30533 +5333 4 54.0929 41.151 24.0537 -8.8009 -7.19084 1.91562 +5334 6 47.531 32.0044 22.8424 -9.22212 4.73076 14.8806 +5335 4 47.3777 32.6735 23.5302 -5.63931 6.65432 -9.88941 +5336 4 48.2144 31.4763 23.2497 9.41484 -5.26157 -3.09765 +5337 6 24.6289 26.1478 33.0175 -22.0968 -9.02062 -12.6011 +5338 4 24.4656 25.5474 33.7557 -1.10221 8.12594 5.97613 +5339 4 25.4283 26.6445 33.1202 14.9272 4.196 4.65224 +5340 6 21.3417 17.0876 39.4763 -6.70912 6.89414 0.748051 +5341 4 22.0272 16.5901 39.8927 14.9242 -9.38388 2.18929 +5342 4 20.9728 17.5957 40.2063 -4.43123 6.71259 -1.60026 +5343 6 11.0417 40.4515 17.0271 -4.84825 -47.9733 -31.3307 +5344 4 11.617 41.1325 17.3235 21.4854 16.9952 0.793724 +5345 4 11.529 39.8797 16.3454 -22.439 27.66 32.3414 +5346 6 20.3522 21.2696 39.8718 -25.2322 13.8952 23.2629 +5347 4 20.7065 20.9823 39.0558 13.3567 -12.8249 -34.1322 +5348 4 21.0787 21.2544 40.4999 1.2931 1.07094 1.93889 +5349 6 2.11891 29.6947 22.5962 -10.9271 -4.15175 -1.48688 +5350 4 1.41229 29.0196 22.6861 11.0269 1.69063 -12.8134 +5351 4 2.97173 29.2673 22.4434 -6.16143 -1.40449 -3.11444 +5352 6 36.756 30.301 35.4561 22.3149 -30.6991 6.56967 +5353 4 36.1659 29.9908 36.1617 3.98829 10.9575 -2.82389 +5354 4 37.5905 29.761 35.5884 -25.1141 24.4323 0.251817 +5355 6 12.9563 4.31922 37.9158 -41.9162 -7.49401 17.923 +5356 4 12.213 3.67486 38.0016 27.2031 5.98064 4.05536 +5357 4 12.5797 5.11915 38.3509 20.8388 -3.72048 -10.4757 +5358 6 38.3368 5.25882 18.4553 -27.9454 13.7946 -11.1943 +5359 4 37.494 5.12162 18.8921 -4.17763 4.09508 -3.9191 +5360 4 38.9486 5.03087 19.1262 32.9808 -9.34357 19.7422 +5361 6 10.4991 9.23341 21.7308 -20.3579 1.12747 21.1104 +5362 4 10.1476 9.35811 22.629 -2.53412 -6.58654 -7.03761 +5363 4 11.4429 9.27697 21.8681 13.0367 -0.194449 -11.5952 +5364 6 0.510441 41.039 17.3204 -22.411 45.8537 -1.19125 +5365 4 1.10275 40.3438 17.515 21.9532 -27.5034 12.6219 +5366 4 0.955429 41.8901 17.5577 -0.403404 -22.4144 -8.21181 +5367 6 4.11028 5.06714 6.43108 -32.0559 -10.673 -25.0156 +5368 4 4.76196 4.43778 6.68194 21.2279 -22.0503 -6.17775 +5369 4 4.3376 5.79555 6.94869 8.69612 42.0455 26.6358 +5370 6 11.4527 25.4042 0.173069 -8.87291 20.1751 -4.43043 +5371 4 11.3037 26.302 0.51034 -2.48968 -2.12098 1.34892 +5372 4 12.3912 25.256 0.330533 -7.09022 -12.0676 2.67745 +5373 6 7.43008 21.5598 8.10589 6.84767 -16.7382 -30.018 +5374 4 7.67559 21.2373 7.18738 -12.1375 12.6211 33.8068 +5375 4 8.24892 21.8626 8.52003 -6.07298 -1.72571 -6.46698 +5376 6 47.5896 16.3642 25.2431 -28.5582 13.6976 -25.6498 +5377 4 46.6075 16.1608 25.1822 37.2389 5.55574 -4.66364 +5378 4 47.8562 16.8152 24.3682 -3.16196 -14.4146 40.515 +5379 6 30.9292 19.5125 39.8483 -41.4217 8.94898 -20.4144 +5380 4 31.859 19.4188 40.0164 22.9308 8.40553 1.58818 +5381 4 30.7224 20.3633 39.3589 16.5857 -27.3682 15.8932 +5382 6 20.3871 24.0387 39.4036 8.00795 23.2793 -8.75093 +5383 4 19.459 24.1701 39.2693 -20.2994 13.2523 2.58474 +5384 4 20.4244 23.1071 39.4874 5.50164 -36.2952 5.14995 +5385 6 45.8871 21.2471 41.1655 20.5283 25.7578 0.477301 +5386 4 46.6385 21.2626 41.7552 1.12624 -15.6366 20.1575 +5387 4 46.1812 21.9667 40.5962 -14.858 0.0662744 -14.6758 +5388 6 32.5732 28.1983 30.4559 17.8923 -19.7368 14.2663 +5389 4 32.9661 27.3096 30.6426 -14.7491 22.8943 -8.37245 +5390 4 33.2232 28.8091 30.8453 -8.57676 -1.81844 -4.53088 +5391 6 18.0207 1.32021 27.0363 -34.7874 1.53884 20.0911 +5392 4 17.0721 1.60205 27.1202 27.3864 -5.2263 -11.315 +5393 4 18.3294 1.50373 27.9381 11.4124 1.84961 -11.8648 +5394 6 39.378 24.9761 21.8758 -21.83 -3.15726 3.51608 +5395 4 39.2925 25.9351 21.9975 13.0773 -1.30024 -1.60914 +5396 4 38.5262 24.6687 22.2439 10.6836 3.42961 -4.87158 +5397 6 33.5904 21.3057 22.0908 0.876878 23.3779 1.34154 +5398 4 32.7037 21.4589 21.7601 -6.64994 -10.6299 -4.35651 +5399 4 34.0298 22.1428 21.8479 4.87062 -13.8873 3.79153 +5400 6 40.1162 15.0006 15.7553 -16.7667 -72.1851 -56.1125 +5401 4 39.3246 14.5665 15.2764 38.6699 22.9899 20.5541 +5402 4 39.7685 15.7046 16.224 -23.0828 51.553 35.6364 +5403 6 32.7063 17.9241 6.36312 -6.65812 28.0098 -27.693 +5404 4 32.6631 17.3286 7.08836 -4.96405 -26.2659 23.6138 +5405 4 32.2202 17.5402 5.61621 0.349997 -9.22032 2.43078 +5406 6 50.4717 15.9308 31.1336 -57.0185 -34.1342 43.3708 +5407 4 51.2677 16.1483 30.7347 55.5832 16.4654 -29.6643 +5408 4 50.5499 15.0059 31.4683 -2.42192 20.1529 -11.8828 +5409 6 23.8292 29.3322 31.6407 10.3974 -8.56959 5.42825 +5410 4 23.7096 29.6981 30.7618 4.3803 -0.813234 -2.10966 +5411 4 24.6813 28.8378 31.6594 -15.3785 13.3689 -4.34977 +5412 6 25.0524 41.6477 38.2806 4.00174 7.46449 -31.3583 +5413 4 25.6511 41.367 37.5454 -10.3054 -0.491554 23.0497 +5414 4 24.5276 0.474703 37.8884 8.98972 -6.87862 14.9811 +5415 6 14.3299 25.4693 7.99598 -51.8246 -23.5651 26.6357 +5416 4 15.0301 25.7523 7.4663 39.147 18.3395 -31.3738 +5417 4 13.6749 25.0466 7.38907 19.2382 9.49844 7.52052 +5418 6 17.2117 20.7467 5.34291 -12.6959 30.9635 29.5807 +5419 4 17.5658 20.2645 4.6512 13.3362 -42.6322 -45.6451 +5420 4 17.6752 21.5763 5.21476 -4.76461 12.1014 12.8322 +5421 6 18.8578 10.961 23.7113 11.9098 -52.6755 14.4862 +5422 4 18.5821 10.3312 23.0139 -2.7304 18.9854 0.947207 +5423 4 18.7069 11.8432 23.4586 -8.32501 34.3086 -18.4054 +5424 6 7.80658 41.3805 11.0401 -9.04392 11.0606 6.15122 +5425 4 8.00429 40.5098 11.4059 2.67644 4.01258 -4.23655 +5426 4 8.51691 0.066 11.3394 -1.81513 -7.16892 -1.05394 +5427 6 48.6966 23.1832 34.0648 -27.3561 -6.76338 -18.0805 +5428 4 48.0792 22.9132 33.32 19.6766 11.2437 24.8207 +5429 4 49.5669 23.23 33.6693 11.2336 0.854645 -6.12438 +5430 6 53.7246 23.5588 15.3422 -2.2993 4.88061 -38.5045 +5431 4 54.0115 23.9686 14.4981 1.04624 9.96871 20.6807 +5432 4 53.2132 22.8493 14.9574 -7.54922 -9.79714 16.7607 +5433 6 22.2409 5.63035 9.83732 -4.74687 0.990813 -28.4051 +5434 4 21.8007 4.9012 9.36518 5.41421 2.33681 17.3637 +5435 4 22.5704 6.16354 9.07597 -3.08255 -9.23766 25.1176 +5436 6 33.6677 8.38805 9.07277 4.65141 2.45263 2.68713 +5437 4 32.9476 8.96499 9.32099 -11.143 10.7473 10.4723 +5438 4 33.4213 8.08448 8.2012 2.38155 -0.0587928 -10.5973 +5439 6 47.3188 37.7205 20.3441 15.215 11.7573 -25.0114 +5440 4 47.5704 37.5879 19.4187 8.2864 3.06637 8.88956 +5441 4 46.6261 37.0853 20.3703 -21.7602 -22.9037 19.9419 +5442 6 30.8605 16.7391 10.6102 -28.0995 -48.2853 23.2284 +5443 4 30.4428 17.1675 11.4048 8.00556 -5.70758 -17.8294 +5444 4 30.5213 15.7576 10.5828 6.17084 54.1408 -3.58748 +5445 6 48.1227 27.723 10.1192 -17.271 38.6552 19.8549 +5446 4 48.941 27.5885 10.6019 15.4404 -6.10886 -7.64033 +5447 4 47.9667 27.1056 9.42146 1.69339 -23.2576 -13.9441 +5448 6 27.3465 38.6397 25.5972 -19.3603 -43.7567 25.3821 +5449 4 28.2552 38.3171 25.6348 3.73027 6.4174 -6.06634 +5450 4 27.3175 39.4354 25.1025 9.7616 28.5552 -11.1584 +5451 6 33.3485 5.72785 21.4502 -30.5322 15.1217 -10.2054 +5452 4 32.7106 6.21453 20.8566 24.3968 -18.0484 15.2917 +5453 4 34.2142 6.02589 21.2258 21.3261 10.3595 -12.9949 +5454 6 25.3097 5.14436 4.52462 -12.6707 -6.42781 10.7366 +5455 4 25.8166 5.03621 5.34324 9.24373 -0.000563512 -7.52253 +5456 4 24.4109 4.89546 4.80865 9.45245 1.955 -8.20101 +5457 6 40.4804 35.6472 19.1595 -4.18239 -17.2552 -25.1441 +5458 4 40.6473 35.1871 19.989 -0.677015 6.66802 10.9293 +5459 4 40.3876 36.5867 19.2889 2.08163 9.85771 9.62751 +5460 6 49.6466 30.6357 19.0258 14.8172 21.4531 -43.5404 +5461 4 50.0494 29.991 18.4245 -6.82309 -11.6442 2.45506 +5462 4 49.4912 30.1943 19.8303 -8.11919 -24.8089 39.0949 +5463 6 42.1414 28.3198 17.0336 30.9261 -8.96587 16.5499 +5464 4 41.9014 28.1134 16.1233 0.612516 -1.09878 -6.61247 +5465 4 42.9986 27.8356 17.2327 -32.0588 11.6021 -17.9905 +5466 6 47.7009 24.529 36.3602 12.6164 -10.6945 -29.4467 +5467 4 46.9511 23.9476 36.4057 -12.614 -6.01445 14.1932 +5468 4 48.02 24.3175 35.4647 6.89481 1.31964 6.68358 +5469 6 19.3487 26.9773 19.8132 -7.91098 29.1703 -3.69101 +5470 4 19.5772 26.0513 19.7652 -2.42994 -17.6971 2.90599 +5471 4 18.7132 27.1892 20.5145 5.94626 -13.5516 -3.80193 +5472 6 47.0594 26.8038 37.5124 29.171 -27.35 55.5912 +5473 4 46.5442 27.3901 37.0243 -28.7601 35.2651 -40.4696 +5474 4 47.4575 26.1126 36.9775 -8.83233 1.8809 -11.4479 +5475 6 9.306 24.6801 40.2841 31.4937 0.109789 0.329283 +5476 4 9.78189 23.9102 39.8717 -14.0424 16.7407 17.3327 +5477 4 10.0272 25.2082 40.7306 -19.6308 -16.1327 -14.1874 +5478 6 14.4855 17.9139 14.2735 23.8217 -2.3356 -5.96097 +5479 4 13.7756 18.1909 13.6871 -0.445295 3.10639 3.20472 +5480 4 15.2926 17.8532 13.6969 -24.9099 1.36359 15.4275 +5481 6 37.1333 38.6708 18.7289 9.24178 15.507 -32.6939 +5482 4 36.7257 39.5382 18.5851 -4.02817 -0.227247 6.07181 +5483 4 37.6697 38.5833 17.9067 -2.91955 -11.3843 16.172 +5484 6 11.4153 5.92336 21.4477 15.4675 -15.5323 24.3843 +5485 4 12.0347 5.46444 22.0611 -14.8481 11.1792 -11.8992 +5486 4 10.9828 5.22117 20.955 -5.02219 -4.37746 -7.57367 +5487 6 4.24672 30.7112 16.2271 25.0754 -37.7862 10.5022 +5488 4 4.05441 31.4608 15.7204 -4.71706 34.9582 -31.1175 +5489 4 3.72964 30.8334 16.9988 -11.892 -2.06994 24.4228 +5490 6 17.6689 16.0105 27.0706 -11.532 -19.4613 -16.5334 +5491 4 17.475 15.0322 27.0999 0.550485 29.0366 -12.0979 +5492 4 17.2014 16.3875 26.2691 10.8221 -16.0252 20.0561 +5493 6 36.4979 8.6445 40.4253 22.1182 5.90925 -1.87084 +5494 4 36.6649 9.56092 40.6574 -3.64727 2.10984 0.486612 +5495 4 35.6642 8.36755 40.7885 -12.5441 -1.64485 2.44437 +5496 6 13.6104 12.9476 3.01337 -0.796658 -1.76047 52.4558 +5497 4 13.281 12.534 3.85665 2.0295 3.09436 -35.1239 +5498 4 14.3672 13.4568 3.35498 1.79634 -1.71495 -16.7359 +5499 6 38.5663 20.1511 21.6276 16.2684 -2.59448 10.3838 +5500 4 39.225 20.3435 20.957 3.66548 0.723189 -1.42015 +5501 4 37.7399 20.1987 21.178 -26.4348 -4.9091 -11.1397 +5502 6 51.0002 10.2707 30.836 -20.0759 -41.5967 21.7358 +5503 4 51.4945 11.0341 30.626 15.2265 30.1997 -10.6067 +5504 4 50.365 10.1656 30.1217 2.42758 1.75416 -9.76943 +5505 6 16.2768 2.44039 41.3342 24.5898 23.894 -47.9169 +5506 4 15.7659 1.68969 41.4668 -26.4768 -52.1654 31.458 +5507 4 16.2309 2.46185 40.3616 9.12406 8.41144 7.6857 +5508 6 16.5823 4.96192 41.8916 -4.82165 52.2801 -70.6027 +5509 4 16.7504 4.9538 0.881833 10.2709 -3.72182 62.3109 +5510 4 16.3825 4.09214 41.6138 -6.48385 -26.7637 5.90228 +5511 6 38.2132 37.6512 20.9834 35.6931 -0.0015793 9.16781 +5512 4 38.1132 38.2158 20.1985 1.71026 -5.63736 5.42755 +5513 4 39.175 37.679 21.2752 -35.8773 5.52261 -11.9395 +5514 6 27.3063 1.90932 15.7743 -36.1781 7.04456 22.02 +5515 4 27.5288 1.21363 15.1745 3.62804 -9.29946 -19.0329 +5516 4 26.3092 1.89423 15.8276 27.8398 0.929522 -3.41863 +5517 6 29.0129 12.4346 37.8081 29.6396 -2.3639 23.3235 +5518 4 29.5703 13.228 37.8521 -9.25731 3.38449 -11.2245 +5519 4 29.432 11.8866 38.5178 -20.735 6.92768 -10.3763 +5520 6 46.0725 20.1624 18.9069 6.39102 14.9163 -14.6323 +5521 4 45.1723 20.516 18.8892 1.91785 -0.379773 0.405435 +5522 4 46.587 20.7656 18.3221 -3.54001 -13.7442 9.74416 +5523 6 2.03634 38.6845 18.4933 3.82981 -3.85695 21.6638 +5524 4 2.81563 38.6864 19.0472 23.4807 10.2435 -12.678 +5525 4 1.45125 38.3557 19.1766 -27.1945 -1.99387 -8.3623 +5526 6 44.0469 24.9707 25.966 7.80173 10.6441 20.9452 +5527 4 44.2747 24.0363 26.0952 1.37736 2.33249 -4.33209 +5528 4 43.5784 25.0701 25.1359 -3.49858 -7.6437 -6.59112 +5529 6 5.98346 26.6137 4.53144 23.0758 4.04073 24.4329 +5530 4 6.55391 27.1627 5.13089 -15.1794 -12.3526 -15.6845 +5531 4 6.29729 25.6938 4.67268 -13.7287 18.2257 -9.78447 +5532 6 0.087877 23.2081 10.934 24.9145 3.46447 1.10559 +5533 4 0.685292 23.7315 10.3726 -8.08066 -2.01306 3.92681 +5534 4 0.721975 22.7627 11.5282 -19.4067 -0.934622 -1.78644 +5535 6 39.1228 20.6282 12.8796 23.5823 -4.01912 3.74068 +5536 4 40.0483 20.9095 13.1274 -25.2182 -11.8294 -4.75086 +5537 4 38.9288 21.0058 12.0111 3.51405 8.21934 1.48951 +5538 6 39.9585 39.9542 18.8548 8.25477 7.63818 -34.14 +5539 4 39.6086 40.5348 18.1328 12.8912 -23.3113 16.3656 +5540 4 39.4227 40.1355 19.596 -22.4924 5.25798 25.9214 +5541 6 49.2764 23.011 30.5163 -3.77364 -44.6036 15.8547 +5542 4 49.4289 23.7872 30.0082 18.6126 30.182 -14.9565 +5543 4 49.9621 22.8706 31.1946 3.66181 18.5012 -4.70792 +5544 6 10.3518 2.34263 9.13761 -0.60969 70.0656 33.4022 +5545 4 10.2194 1.51752 8.76453 -19.3013 -48.5596 -30.1763 +5546 4 9.57958 2.95755 9.02478 16.8019 -18.7251 -1.57756 +5547 6 9.61453 40.9339 19.7468 19.8516 -54.9951 -16.0575 +5548 4 9.63195 40.6865 18.7859 0.317082 16.3896 20.6195 +5549 4 10.0376 40.0904 20.1458 -24.9194 43.0231 -10.2629 +5550 6 29.2525 5.10109 17.4961 7.67774 22.6856 2.90325 +5551 4 29.0408 4.77134 16.6193 -6.82779 -3.03985 -6.7526 +5552 4 29.5295 6.02934 17.3335 -2.58265 -16.5067 4.76001 +5553 6 27.0985 15.4102 3.23556 -13.4453 -81.1273 -7.3603 +5554 4 27.3652 16.2806 3.27349 18.8182 67.1491 11.283 +5555 4 27.7776 14.8512 3.68225 -14.3437 21.6428 -0.863725 +5556 6 32.8444 39.3852 25.121 -7.01244 -52.8845 44.4676 +5557 4 32.5131 40.2222 24.9368 -10.8075 51.8916 -16.2411 +5558 4 32.4445 39.2315 26.0289 16.1191 -0.874654 -30.671 +5559 6 34.9513 7.88207 31.2328 20.4504 58.5219 2.42802 +5560 4 34.2036 8.45679 31.498 3.65199 -12.2289 -1.35309 +5561 4 34.6861 6.99719 31.2488 -20.0023 -44.0519 1.25651 +5562 6 6.12467 36.7605 26.1486 23.5936 30.152 20.8626 +5563 4 6.61267 37.4751 26.6609 -18.7565 -29.2185 -15.3031 +5564 4 6.64666 36.6639 25.3566 0.873799 -8.15108 -9.63468 +5565 6 6.01736 25.8242 24.1032 -23.71 11.4997 43.6127 +5566 4 6.27054 25.4519 24.9889 5.69321 0.899098 -34.3464 +5567 4 5.25039 26.3671 24.4036 11.002 -12.3451 -22.9516 +5568 6 45.616 24.3868 2.54557 6.93899 11.9467 -1.18645 +5569 4 46.5025 24.2318 2.18535 0.269069 -11.0786 2.08994 +5570 4 45.6283 24.2142 3.48441 5.93067 -6.10702 12.3332 +5571 6 15.5106 11.7053 32.6869 22.7313 15.5035 25.4621 +5572 4 15.7644 12.551 33.1413 -9.31293 -24.2108 -12.4541 +5573 4 14.956 11.9719 31.9681 -12.2379 8.7831 -14.7046 +5574 6 46.4141 17.7037 37.4783 -24.8433 -42.9552 -46.1347 +5575 4 46.5841 17.8832 38.3706 6.4658 9.03355 44.3658 +5576 4 46.0203 16.778 37.4148 6.08678 36.5836 2.96135 +5577 6 39.713 20.917 18.528 13.2313 30.5311 40.8197 +5578 4 40.433 20.5782 18.0298 13.2747 -18.0123 -24.5712 +5579 4 40.2054 21.5165 19.1543 -30.2447 -12.7963 -15.6911 +5580 6 23.8051 28.0334 36.6648 -18.7533 17.1228 48.8478 +5581 4 23.301 27.37 37.1661 8.15196 -5.41595 -20.5023 +5582 4 23.699 28.7533 37.3439 14.557 -4.10395 -29.4534 +5583 6 23.235 0.659798 30.8906 16.7198 -34.3804 0.301059 +5584 4 23.3562 41.8891 31.5781 -2.93034 5.1259 -1.85649 +5585 4 23.9222 0.433479 30.2226 -16.4688 10.6885 3.12481 +5586 6 37.1438 6.89027 28.2945 -2.75708 2.50278 32.0481 +5587 4 36.7625 6.23385 28.9496 14.7229 22.3106 -21.8828 +5588 4 37.4874 7.65333 28.8474 -13.0775 -21.14 -18.6628 +5589 6 3.23769 6.61111 12.3846 0.723209 -17.9385 -9.61551 +5590 4 2.93962 6.7917 11.4726 6.04883 11.0603 10.3219 +5591 4 3.59705 5.70622 12.3141 -7.8292 10.6871 9.81534 +5592 6 12.6213 19.1513 31.1215 -11.7593 -39.2703 -9.13055 +5593 4 12.5689 18.1911 31.4279 4.41954 36.1073 -0.401864 +5594 4 12.3049 19.0952 30.1995 4.23471 8.33584 13.9505 +5595 6 15.1895 38.3194 41.5508 -8.26313 0.106571 5.96729 +5596 4 15.4027 38.685 40.6867 1.58925 3.7734 1.08261 +5597 4 15.977 37.8419 41.8199 8.82113 -1.67422 -0.112624 +5598 6 49.6344 33.3417 19.6414 -43.1776 -42.2962 -0.847743 +5599 4 48.6794 33.3996 19.9697 35.2792 3.84356 -17.7841 +5600 4 49.66 32.3974 19.2778 11.8172 40.1309 17.1575 +5601 6 6.36572 2.78375 29.9004 1.05055 15.8156 -22.8281 +5602 4 6.36575 3.75042 29.7262 1.90425 -15.9719 7.25575 +5603 4 5.96593 2.68858 30.7619 0.24665 -4.47807 16.8647 +5604 6 13.1696 31.768 30.2754 -6.44409 10.1839 -14.6274 +5605 4 12.7931 32.0108 29.386 8.00869 -8.49993 19.6421 +5606 4 12.9985 30.8211 30.4317 -1.17466 7.15103 -3.10169 +5607 6 32.315 32.2433 24.9103 28.3535 -13.0924 -48.465 +5608 4 32.6582 31.5201 24.3183 -18.8106 4.4732 28.5514 +5609 4 32.6906 33.004 24.4312 -3.21058 9.63112 20.1287 +5610 6 42.0003 14.5628 37.421 -39.889 12.6212 -8.37855 +5611 4 41.095 14.1415 37.3281 37.9102 -1.96214 -0.320241 +5612 4 42.7025 13.9066 37.3517 -4.02931 -15.6388 2.60245 +5613 6 11.8892 7.23447 27.6701 3.45884 -4.12236 4.5236 +5614 4 11.8415 6.40302 28.2109 -4.80024 17.2153 -14.4092 +5615 4 11.297 7.16355 26.8983 -0.411327 -9.99206 8.34553 +5616 6 14.2054 37.5349 6.88535 -5.50304 -50.1586 -23.8091 +5617 4 14.4448 38.4425 6.82842 11.1201 34.2121 -5.16838 +5618 4 14.5404 37.0855 6.04727 -8.45912 19.5264 31.302 +5619 6 14.2389 30.7101 36.0658 7.9951 22.3707 -6.00421 +5620 4 14.3369 30.7582 35.119 5.20948 5.89711 -15.5268 +5621 4 14.162 29.7856 36.1796 -2.50712 -40.828 17.27 +5622 6 16.4199 33.6465 5.49971 39.8982 -12.4718 -37.0106 +5623 4 16.8881 34.472 5.38053 -10.1033 13.7438 12.8324 +5624 4 16.9383 33.116 4.82328 -31.4907 -2.1142 22.2677 +5625 6 23.0347 17.1509 7.84843 -2.98061 53.305 10.417 +5626 4 22.2528 17.4913 7.37616 0.35347 -20.1342 1.7373 +5627 4 23.3535 18.0122 8.2624 2.91922 -40.8936 -9.01863 +5628 6 51.739 20.8998 27.7117 45.1346 -9.91933 19.8422 +5629 4 51.4539 20.5938 28.5983 0.576611 5.87017 -14.8878 +5630 4 52.7517 20.9693 27.7878 -43.3794 -0.870523 -11.1135 +5631 6 2.19386 27.6013 28.8077 21.9852 1.77593 -20.6905 +5632 4 2.90112 28.2633 28.7865 -8.94698 7.25322 21.5481 +5633 4 2.57794 26.9939 28.1568 -21.2327 -10.3447 8.82052 +5634 6 17.2209 14.3445 7.70498 -9.6153 -40.0176 25.3709 +5635 4 16.7414 14.2178 8.5755 19.2823 5.01031 -25.0594 +5636 4 17.7242 13.4894 7.54274 -12.7499 32.9606 1.11211 +5637 6 12.4553 8.94194 14.7093 23.4905 -30.5738 22.1451 +5638 4 12.3295 7.96561 14.6517 -10.6336 18.1935 -14.5798 +5639 4 13.0902 8.95069 15.466 -13.8235 22.031 -14.7981 +5640 6 42.4163 38.0607 9.75492 -41.3892 12.3524 0.930734 +5641 4 43.2155 37.8504 10.1985 23.5031 -2.65638 19.8551 +5642 4 41.8128 38.5249 10.3845 19.1619 -5.0707 -9.72644 +5643 6 51.8291 30.3524 28.2725 -23.4976 -15.3182 24.0858 +5644 4 51.4769 31.1806 28.0071 -16.9091 20.9854 -6.54852 +5645 4 52.5669 30.2698 27.7075 37.0459 -10.0857 -13.876 +5646 6 0.173291 18.5306 4.58887 -6.78508 26.3933 6.63194 +5647 4 0.366643 18.0957 3.77581 2.61413 -8.62723 -27.1515 +5648 4 0.528197 17.9664 5.25604 0.668563 -20.2899 17.5992 +5649 6 34.1542 0.618182 3.01035 -64.6642 7.59467 -29.5426 +5650 4 33.2756 0.91071 2.55681 38.9521 -14.8268 28.0312 +5651 4 34.8139 1.0189 2.46529 20.392 14.9436 -5.19898 +5652 6 49.1703 17.2445 23.163 11.3421 -28.7232 -23.3687 +5653 4 50.0948 17.5226 22.997 -11.4987 -1.8789 7.34388 +5654 4 49.1149 16.3391 22.7575 3.35316 27.0342 8.27414 +5655 6 23.1508 6.50484 23.6205 15.3745 23.1125 -33.0506 +5656 4 23.1854 7.14565 22.8174 -14.1016 -25.0292 28.8988 +5657 4 22.2566 6.27815 23.8868 -11.3625 11.3028 -1.57795 +5658 6 11.0777 24.0866 29.2726 3.42799 -14.5151 -26.2344 +5659 4 11.3051 23.4915 28.5104 -10.7193 12.1306 15.2701 +5660 4 11.7189 23.8646 29.9475 6.00027 1.59973 10.1126 +5661 6 36.5499 4.08922 21.6769 -9.80126 5.87302 -21.3361 +5662 4 36.3976 4.50823 22.521 3.21878 -0.144303 13.033 +5663 4 36.3054 4.80832 21.0596 6.63301 -13.9203 1.83546 +5664 6 31.3023 25.6432 24.5943 15.0376 6.85795 28.0728 +5665 4 31.291 26.2789 25.3519 -12.6017 -14.5788 -25.478 +5666 4 32.0941 25.1064 24.7955 -9.59576 -0.449362 -7.93794 +5667 6 42.6065 23.029 14.7662 -46.2562 -12.0705 -53.1337 +5668 4 42.8654 23.3474 13.8766 8.33796 6.77145 13.2285 +5669 4 43.1929 23.285 15.4255 44.8404 21.8098 38.991 +5670 6 14.3111 11.6689 8.88632 -19.0153 -23.9468 -21.906 +5671 4 13.3495 11.3817 8.87766 31.9146 14.5471 0.24728 +5672 4 14.742 11.0378 8.25313 -7.14597 12.5116 20.7778 +5673 6 21.4992 2.13393 3.40246 8.36864 -2.88126 -9.61958 +5674 4 22.4231 2.22963 3.69686 -12.58 -3.45743 -2.69439 +5675 4 21.4721 1.34946 2.81138 2.62282 6.56171 18.4043 +5676 6 22.4667 27.6841 39.0793 -16.1771 -11.2193 -33.3168 +5677 4 22.9487 28.2311 39.6723 13.8114 13.1168 21.0188 +5678 4 22.2331 26.8853 39.529 -0.753476 -8.75647 11.2468 +5679 6 37.2752 33.5075 30.0534 -5.09816 -29.8969 21.2662 +5680 4 36.5321 32.9121 30.2938 11.1992 13.6878 -5.37502 +5681 4 38.0391 33.1092 30.5204 -9.59535 7.6329 -11.7718 +5682 6 41.8356 20.8755 40.0084 -30.1785 -26.2846 -15.3963 +5683 4 40.891 20.6843 40.2338 21.7839 7.55089 -6.55796 +5684 4 42.213 21.2736 40.7728 12.4306 8.07023 23.0746 +5685 6 10.0585 31.1051 22.2503 24.8691 -18.1602 32.094 +5686 4 10.0242 30.9652 23.2199 -0.323131 -4.21186 -18.2592 +5687 4 9.26251 31.5457 22.0526 -32.5358 14.9165 -12.561 +5688 6 24.2061 35.3797 6.65176 29.8647 -7.74501 -52.0461 +5689 4 23.2981 35.13 6.46942 -12.5131 3.59528 11.7489 +5690 4 24.436 35.6291 7.5325 -13.5066 3.92126 26.0938 +5691 6 54.2205 13.3707 18.7548 -14.8606 0.23157 2.49876 +5692 4 53.5905 13.2954 18.0026 12.0308 5.79113 16.3195 +5693 4 53.7072 13.5032 19.578 4.97112 -2.65932 -16.1217 +5694 6 12.4895 25.0856 17.4479 -5.54126 21.12 19.6166 +5695 4 12.0527 25.8035 17.9613 1.96295 -15.4272 -10.9144 +5696 4 12.9797 24.5872 18.1192 -7.22993 -2.38631 -13.5888 +5697 6 22.3914 33.9622 18.8899 -17.7941 -3.8788 -25.186 +5698 4 22.7777 34.3519 18.0802 1.20341 3.55679 12.7761 +5699 4 21.5828 33.5138 18.532 26.0363 5.82114 13.25 +5700 6 24.4442 12.917 5.83205 -1.35281 -9.13891 6.68087 +5701 4 24.5112 13.8355 6.04562 11.139 23.8521 5.95609 +5702 4 23.7978 12.9208 5.12829 -4.38592 -8.75699 -5.70796 +5703 6 13.4045 11.2384 28.602 -9.94106 -32.5269 -0.345522 +5704 4 13.7125 10.4202 28.1467 1.06973 22.7078 1.68844 +5705 4 12.6883 10.856 29.1417 2.50959 12.0169 -5.49025 +5706 6 20.9681 34.6931 21.1354 15.1203 14.42 -6.16036 +5707 4 21.5009 35.1121 21.8248 -8.94458 -7.77672 4.1779 +5708 4 21.5063 34.8208 20.3262 -11.2236 -10.4562 8.09593 +5709 6 37.1336 34.5207 26.1541 -9.5297 -36.7224 -3.07541 +5710 4 37.2109 34.2142 25.2288 3.21082 15.1766 11.7274 +5711 4 37.5352 35.3664 26.2639 8.9577 18.3348 -6.65469 +5712 6 49.3622 27.1182 23.4746 39.7066 -11.0301 13.9767 +5713 4 48.4746 27.3502 23.3119 -43.65 9.96054 -8.06751 +5714 4 49.6716 26.7458 22.6451 -3.30563 -9.15784 -7.68388 +5715 6 2.6564 41.733 27.6477 -1.65257 -10.3676 0.180548 +5716 4 2.5349 41.5868 26.6785 2.71482 14.5166 10.808 +5717 4 3.44733 0.360291 27.8573 -13.8821 -2.9337 -13.5775 +5718 6 28.2538 5.65865 0.855763 -50.2522 -11.1502 7.99105 +5719 4 29.1126 5.92525 0.635025 43.8938 8.11388 -11.2713 +5720 4 28.2366 4.68907 0.832778 5.05155 4.08711 2.73992 +5721 6 46.3376 19.9476 30.6448 -5.32264 7.02196 22.3264 +5722 4 46.9473 19.8004 29.9179 3.84913 9.17517 -5.42643 +5723 4 46.6125 20.7672 31.1318 -5.12963 -19.3092 -16.4827 +5724 6 3.64577 25.7701 21.5553 -12.766 27.4814 -12.397 +5725 4 3.72382 24.8593 21.8343 3.84868 -9.88757 -5.52558 +5726 4 3.13913 25.8588 20.7173 13.2009 -15.3518 9.10855 +5727 6 2.75122 19.0968 29.6319 -2.61118 -0.882922 8.96218 +5728 4 3.5891 18.6871 29.8565 3.14038 -9.81989 10.1431 +5729 4 2.90737 19.4327 28.7602 3.1882 14.1904 -12.7773 +5730 6 11.8953 35.7778 24.2646 -23.8517 23.4638 0.926703 +5731 4 12.2722 34.9198 24.2954 23.5909 -23.1933 0.784725 +5732 4 12.5229 36.3761 23.8548 12.2449 3.68762 -3.83655 +5733 6 52.3409 30.3775 14.3038 25.9342 24.3497 3.27132 +5734 4 52.8186 31.1218 14.7277 1.28259 -10.3571 -1.87569 +5735 4 51.5459 30.7912 14.0165 -25.7225 7.74731 -5.34623 +5736 6 0.083662 24.3704 32.1159 7.87696 -1.86575 0.949534 +5737 4 0.925887 24.7254 31.8116 -7.58302 1.2158 -10.0766 +5738 4 0.064605 24.6797 33.0182 -11.6947 5.89195 12.8097 +5739 6 31.4941 23.7355 38.8139 13.6067 4.55671 22.3988 +5740 4 31.5922 23.3599 39.6955 6.6148 17.5079 8.63317 +5741 4 30.9989 23.0266 38.4646 -21.4094 -18.5611 -29.2329 +5742 6 52.1193 21.6104 3.49599 14.6151 -31.0847 -13.388 +5743 4 52.9641 21.5934 2.99085 -20.8635 4.42776 5.19501 +5744 4 52.1025 22.4297 3.95509 1.85636 27.8943 8.87727 +5745 6 31.7523 33.9412 11.6017 9.59211 -24.6365 -8.99112 +5746 4 31.343 34.2459 12.4067 -7.95657 10.1636 10.9534 +5747 4 32.0734 33.0348 11.7994 -4.73133 20.193 -2.42319 +5748 6 7.03486 17.6719 16.6685 29.0057 -41.5114 -49.367 +5749 4 6.91092 17.0215 17.3537 -7.78637 4.64801 28.8113 +5750 4 7.29826 17.0034 15.9319 -18.9591 50.1453 28.7374 +5751 6 51.8542 41.8728 22.1898 10.246 17.2442 -13.5357 +5752 4 52.3028 41.4443 22.9054 19.3182 -6.61148 18.5368 +5753 4 51.1068 41.3135 22.0792 -27.0964 -11.4612 -2.03348 +5754 6 50.8737 9.93347 25.9376 -32.929 -21.31 0.307119 +5755 4 50.6075 10.0984 25.0351 -2.54905 2.45869 -5.94774 +5756 4 51.7134 10.3221 26.0527 29.2363 20.0336 5.9403 +5757 6 9.00178 39.8723 13.8451 -19.3622 -18.1235 -30.983 +5758 4 9.55792 39.3182 14.3856 9.60602 -5.37935 8.26515 +5759 4 8.70771 39.29 13.0873 14.4347 20.6992 23.854 +5760 6 40.6986 25.5526 0.136544 19.9096 -17.3535 33.0343 +5761 4 40.3666 25.3638 1.04053 0.834228 7.76146 -13.9079 +5762 4 41.6521 25.7245 0.296606 -16.7956 -8.725 -14.7957 +5763 6 46.6823 7.83196 22.8561 10.1499 25.8504 33.9562 +5764 4 46.2788 7.49308 23.6743 -2.78909 -8.0392 -13.1915 +5765 4 47.099 8.65892 23.1926 -4.50937 -8.82075 -14.1875 +5766 6 20.9875 12.9068 9.95805 -11.691 32.2034 24.7109 +5767 4 21.4351 12.3054 10.5167 21.854 -26.8991 22.1196 +5768 4 21.3309 12.7465 9.11062 12.4417 -9.66517 -44.3579 +5769 6 24.8453 0.514421 28.6038 13.082 22.7197 -2.81433 +5770 4 24.715 0.071792 27.7548 -6.16819 -1.63374 -2.91335 +5771 4 25.0442 1.45997 28.4028 -6.72102 -19.281 3.08734 +5772 6 9.94041 22.6855 8.28517 -18.2906 18.759 -35.6321 +5773 4 10.3442 21.9586 7.83344 17.071 -18.1108 1.7387 +5774 4 9.60436 23.1702 7.48056 7.13277 7.40532 33.7222 +5775 6 33.2759 9.25429 23.8257 8.37106 -55.2845 13.9355 +5776 4 33.3237 10.1123 23.4806 -1.26345 47.1757 -20.4798 +5777 4 34.1087 8.81977 23.5578 -8.47821 6.16632 5.2483 +5778 6 47.7984 20.3614 34.2959 -41.6158 20.0741 -32.6301 +5779 4 47.162 20.9095 33.7523 35.4977 -6.5354 18.8426 +5780 4 47.2264 19.5923 34.4121 13.8381 -6.37745 11.1074 +5781 6 7.49292 13.4971 41.09 9.79805 -11.8131 -23.6679 +5782 4 7.49901 13.1324 40.1715 -6.0705 12.8605 17.5951 +5783 4 8.32745 13.1637 41.4633 -5.36906 3.36653 2.36319 +5784 6 9.96112 23.6102 1.61114 1.89646 0.256416 -8.05524 +5785 4 10.3422 24.1467 0.893187 3.70522 0.0162214 12.766 +5786 4 9.63217 22.8308 1.16111 -2.5861 -8.4474 -3.4617 +5787 6 27.3279 14.1675 11.3384 -16.3978 3.93745 18.7515 +5788 4 27.0565 14.7974 10.6584 -0.154384 0.736593 1.51299 +5789 4 26.9739 14.5213 12.1957 15.9081 -3.44829 -24.7787 +5790 6 25.8416 31.7729 17.8867 -18.6075 -57.137 -13.4601 +5791 4 26.5498 31.1652 17.5816 -7.88637 19.42 8.67928 +5792 4 26.1364 32.6121 18.1157 31.0786 47.9057 11.8145 +5793 6 28.5054 34.3394 0.220618 54.67 33.5077 11.5224 +5794 4 29.0324 33.8757 0.885908 -4.94848 -3.20805 0.921423 +5795 4 27.711 33.8992 0.092994 -46.8158 -31.9819 -6.78258 +5796 6 39.4821 27.6754 22.7241 37.6977 26.8974 -34.7457 +5797 4 38.562 27.8477 22.7631 -35.1425 8.51836 6.28403 +5798 4 39.8483 28.4606 22.2037 -4.4779 -30.5719 17.4824 +5799 6 19.3989 35.5068 37.6449 44.7238 7.00696 26.241 +5800 4 18.7939 34.9286 37.217 -17.2642 -20.3375 -13.2178 +5801 4 20.0787 34.9056 38.0699 -27.4009 15.1777 -18.4057 +5802 6 40.2622 30.2205 10.7395 23.7464 -4.20556 -44.2191 +5803 4 39.872 30.2327 11.5724 -12.5687 -7.32393 56.9787 +5804 4 39.6265 30.6987 10.2193 -5.46151 14.1383 -16.826 +5805 6 44.8252 28.4803 36.0885 -55.5401 -40.4399 48.4955 +5806 4 44.0914 27.9458 36.6324 49.8455 26.3412 -39.6007 +5807 4 44.7386 29.3482 36.4954 11.2485 4.05282 -13.3799 +5808 6 17.9305 13.9374 34.278 5.37655 43.1893 -39.9004 +5809 4 17.3503 14.7126 34.0365 12.4853 -29.216 13.3111 +5810 4 17.5732 13.4499 34.9957 -23.6035 -11.4222 25.4792 +5811 6 22.772 11.7897 25.9182 -5.92321 66.9234 -24.4623 +5812 4 22.4079 10.9608 26.1065 -2.80798 -46.2844 14.8143 +5813 4 23.7282 11.8442 25.9391 13.2658 -20.917 3.34216 +5814 6 27.9678 31.9745 40.3581 9.67064 -3.036 11.5355 +5815 4 28.3415 32.7469 39.952 3.83939 12.9153 -6.44865 +5816 4 27.8423 31.3481 39.6454 -9.64166 -7.41544 0.62615 +5817 6 29.7189 5.14175 29.7003 46.1252 -36.6163 -19.9261 +5818 4 29.2969 5.47215 30.4671 -15.8461 16.6952 32.1509 +5819 4 30.5834 4.69597 30.0017 -39.473 23.5261 -13.8417 +5820 6 3.10812 21.482 2.76797 0.178067 -30.2305 -7.76436 +5821 4 2.88389 22.394 2.68207 -8.68283 21.8462 0.431797 +5822 4 2.52465 20.9987 2.15107 4.11904 7.00085 10.9335 +5823 6 13.6455 30.6616 39.7413 -31.0251 6.24286 -53.6991 +5824 4 14.4958 30.9276 39.9901 40.59 7.52955 18.7737 +5825 4 13.6028 30.9637 38.7781 -13.7388 -14.6365 40.9566 +5826 6 39.1879 23.0833 28.2631 23.8153 34.0131 -40.8644 +5827 4 39.3603 23.1915 27.276 -9.32936 -4.03115 31.7012 +5828 4 38.6771 22.3028 28.3825 -19.3689 -24.2853 3.44718 +5829 6 16.9942 23.7475 0.782551 23.2332 -11.0525 -6.02825 +5830 4 16.1835 23.4907 1.22514 -0.204047 -3.07314 3.44284 +5831 4 17.6924 23.1245 1.11262 -18.9135 18.2649 -2.71213 +5832 6 0.34625 33.6655 13.0265 -29.0282 32.855 38.2597 +5833 4 54.9333 33.1158 13.7076 7.16186 -20.0974 -8.4449 +5834 4 0.196186 34.5312 13.5136 21.864 -23.0202 -35.8666 +5835 6 49.1134 40.6592 16.9502 -22.6074 7.13526 -12.7963 +5836 4 49.0929 41.0585 16.0481 9.95068 -10.3513 11.1088 +5837 4 48.1763 40.6949 17.2078 7.5264 3.31219 -3.37923 +5838 6 52.1371 39.9932 15.179 23.5783 8.13152 6.60826 +5839 4 51.9212 40.0798 16.1068 2.92809 -1.65288 7.91558 +5840 4 51.3496 39.6649 14.7978 -27.1925 -6.99882 -20.2103 +5841 6 29.0492 37.0934 37.8397 27.862 0.580994 -15.5106 +5842 4 29.7824 36.6456 38.29 -13.83 -0.942856 -3.03347 +5843 4 28.3401 37.1923 38.4583 -14.8343 8.34268 17.6028 +5844 6 4.87483 1.47389 27.5722 8.99005 1.78018 0.412076 +5845 4 5.18955 1.04652 26.7639 -2.94161 4.65408 6.15856 +5846 4 5.65876 1.67721 28.1054 -5.69693 -0.488114 1.02013 +5847 6 43.5905 24.3648 30.2005 -22.2044 -15.6763 19.9702 +5848 4 44.3573 23.9419 29.8442 19.8319 -9.6252 -11.3654 +5849 4 42.9995 23.6287 30.4468 4.54232 11.3491 -5.57307 +5850 6 33.7546 3.53169 22.9281 6.20171 -10.3572 -20.5792 +5851 4 34.1788 2.72522 22.5548 -7.61164 22.2296 6.95503 +5852 4 33.66 4.19918 22.2026 -0.715781 -19.232 19.3758 +5853 6 19.8847 13.4579 25.4063 -13.0952 -9.58357 -31.6265 +5854 4 20.5464 14.0819 25.6574 14.0517 10.8301 14.4774 +5855 4 19.8633 12.7253 26.0209 8.35596 -5.88238 10.9252 +5856 6 47.3765 23.175 39.6238 -8.62258 12.6683 8.16714 +5857 4 47.7656 22.5263 39.0394 4.03481 -11.1372 -12.2265 +5858 4 47.7314 24.026 39.3382 2.38196 -1.35255 2.76448 +5859 6 20.1792 18.6695 32.3892 10.8118 -11.8558 9.82813 +5860 4 19.7451 19.3837 31.9609 -18.6549 15.8768 -14.4176 +5861 4 21.1063 18.8885 32.2904 5.57481 -8.22146 4.6255 +5862 6 0.469489 5.80056 25.6694 -18.1951 25.8664 -34.3154 +5863 4 0.192512 6.63022 25.2132 12.4788 -26.9708 -4.90825 +5864 4 0.599388 6.15564 26.5295 8.98284 3.20038 34.2611 +5865 6 6.87796 19.5502 31.9212 -30.9469 28.3562 -15.4034 +5866 4 6.36899 19.9719 32.666 7.94508 -11.3044 -26.1662 +5867 4 6.51823 19.9652 31.058 21.1032 -17.2362 32.6466 +5868 6 6.72006 20.2763 38.5282 -5.5716 11.964 -18.9783 +5869 4 5.89143 20.7831 38.5761 11.8801 -4.42879 -4.55199 +5870 4 6.91977 20.0675 39.4366 -2.33705 -6.77268 4.9945 +5871 6 22.0131 25.9408 12.2669 -3.54377 -45.9259 -44.7125 +5872 4 21.4169 25.4251 11.6232 6.06411 36.0021 36.1209 +5873 4 22.8575 25.5519 12.0003 5.79029 4.70211 8.19546 +5874 6 39.2956 7.94468 2.64777 3.93347 -3.54621 1.69719 +5875 4 39.6192 7.96721 3.55942 2.89932 9.4301 1.57912 +5876 4 39.5223 7.0665 2.33247 5.57505 -8.53159 -3.65477 +5877 6 29.9733 22.0379 34.4029 6.80249 8.99144 -26.5663 +5878 4 30.9486 21.9114 34.4332 -22.6925 2.47334 -4.63229 +5879 4 29.7282 22.2324 33.4511 1.23467 -5.29722 31.1857 +5880 6 37.585 16.2896 0.378862 9.66072 -32.1652 -13.4334 +5881 4 37.1738 15.3958 0.469359 7.4986 19.6703 2.82788 +5882 4 38.3979 16.0784 41.7811 -5.81955 5.34443 7.8674 +5883 6 11.7199 13.8969 21.9024 0.976022 -4.28814 -52.9061 +5884 4 11.762 13.5091 20.9636 8.25344 3.74313 41.2159 +5885 4 11.7301 13.2111 22.5694 -0.197866 -18.3587 0.721586 +5886 6 33.3547 10.9227 27.6206 7.79028 2.98821 -12.2755 +5887 4 32.7398 11.5851 27.2614 8.9286 -8.03905 3.2582 +5888 4 34.0693 10.7866 26.9485 -19.1033 10.7299 13.3482 +5889 6 30.9479 36.5351 10.0985 1.61282 -58.9885 -21.8283 +5890 4 31.0506 36.3975 9.1055 -4.33965 11.8991 35.1417 +5891 4 31.0192 35.5887 10.4601 -6.41155 39.3119 -7.26857 +5892 6 45.5784 6.55949 25.24 49.1938 -13.828 -6.30557 +5893 4 44.6777 6.5515 25.5065 -25.461 -8.09624 7.65514 +5894 4 45.978 5.64009 25.2752 -26.9592 28.1751 -0.0529727 +5895 6 9.53089 30.0259 12.0468 18.203 -29.4993 -35.3826 +5896 4 9.87965 30.5113 11.2809 1.8895 2.86193 6.03312 +5897 4 9.26134 30.6784 12.652 -18.7794 25.6859 27.1844 +5898 6 53.0787 24.9761 1.37462 5.70131 11.5656 52.3682 +5899 4 52.7701 24.171 1.02302 -14.9871 -27.078 -25.8882 +5900 4 53.2426 25.5756 0.676612 4.18045 17.0305 -26.7636 +5901 6 26.1794 24.7359 0.502901 22.1176 -25.6344 -30.1555 +5902 4 25.7034 24.7594 41.5454 1.42755 5.35042 26.0986 +5903 4 25.8798 25.3805 1.12222 -18.0425 21.9232 11.274 +5904 6 23.006 2.41877 11.549 3.03835 0.786733 -23.201 +5905 4 22.1232 2.19651 11.8728 1.75899 -1.65202 1.96434 +5906 4 22.9163 2.42328 10.5701 -3.31062 2.24291 13.1011 +5907 6 29.9286 12.8953 30.9894 2.56623 -0.427284 6.89615 +5908 4 30.7531 12.7948 31.5295 -11.6926 9.48208 -25.7239 +5909 4 30.1452 13.1242 30.0532 3.97045 -7.90132 21.6369 +5910 6 24.0654 16.1863 40.3478 -8.57837 -16.1993 -7.0618 +5911 4 23.8181 16.8167 40.9886 -17.7345 17.1107 43.7161 +5912 4 24.4461 16.799 39.7307 8.03288 -6.21636 -19.956 +5913 6 21.8775 29.9129 12.7438 8.38993 20.3936 0.69825 +5914 4 21.1101 29.6022 12.2761 -16.411 -9.00989 -4.05561 +5915 4 21.7959 30.8814 12.6689 6.66677 -10.3308 5.74649 +5916 6 45.2196 12.276 6.62528 -23.2047 44.1078 30.1736 +5917 4 45.4494 11.529 6.11864 16.0879 -27.9404 -20.133 +5918 4 45.9267 12.944 6.63915 -2.18395 -9.27911 -10.7446 +5919 6 7.59043 25.3914 38.0243 42.7544 -18.087 21.3587 +5920 4 8.2454 25.1294 37.3073 -28.6085 13.3538 22.5553 +5921 4 8.06078 25.1795 38.9036 -17.5445 13.8955 -36.9473 +5922 6 46.1702 7.81994 16.6869 -21.8749 40.0263 -11.2018 +5923 4 46.5308 7.86296 15.7811 2.96678 -6.7279 9.6444 +5924 4 46.6568 7.20863 17.2067 24.29 -27.7199 6.2944 +5925 6 54.9712 12.8519 7.72645 -5.0392 -7.84126 -11.592 +5926 4 54.9715 13.8156 7.65436 -3.45199 -1.13943 9.08655 +5927 4 54.3111 12.5688 8.37934 8.51313 12.0297 -0.864167 +5928 6 26.936 39.6495 37.1759 1.87165 14.912 18.6021 +5929 4 27.6928 39.6002 36.5592 -3.34619 -10.0228 14.3716 +5930 4 27.1866 39.3914 38.108 -0.832196 -0.678219 -33.4669 +5931 6 27.0349 8.92218 38.0169 24.6524 -2.61622 -28.7715 +5932 4 26.316 9.52058 38.1337 -23.9094 17.4181 8.51603 +5933 4 27.4852 9.31616 37.2255 -4.7843 -14.0734 18.554 +5934 6 8.05135 7.65161 29.9116 12.1299 -7.94147 21.2544 +5935 4 8.62851 7.92802 30.6495 -6.35395 -5.29094 -12.0163 +5936 4 7.74814 8.47335 29.5547 -5.2558 18.4649 -14.2469 +5937 6 27.8737 27.8565 12.1051 -38.6038 15.3188 22.9885 +5938 4 27.4445 28.7122 12.3849 14.7215 -19.9621 -4.23437 +5939 4 28.6312 28.0341 11.5799 28.6137 10.9177 -18.1106 +5940 6 23.5548 30.5037 38.1558 -29.4871 -31.9475 26.5081 +5941 4 24.0962 30.758 38.9126 3.93335 7.76671 -5.43794 +5942 4 23.9417 30.8351 37.3772 21.2145 16.4773 -23.4003 +5943 6 48.0793 24.306 17.3344 -19.3615 12.8085 -14.3801 +5944 4 47.2872 24.7421 17.7455 27.359 -7.68532 -3.4425 +5945 4 48.1537 24.7387 16.4546 -0.580236 -6.90317 13.1114 +5946 6 38.498 5.30294 40.3305 40.7021 23.5094 2.62433 +5947 4 38.9475 4.64687 39.7972 -10.9193 -18.4764 2.07144 +5948 4 39.1882 6.01706 40.3225 -28.8653 -3.92995 8.38836 +5949 6 31.2337 3.92695 33.7301 -2.6422 16.6026 -6.87478 +5950 4 31.7948 4.28658 33.0166 -2.97898 -8.44373 7.32517 +5951 4 31.5298 3.03423 33.9266 10.3473 -9.06319 -0.444766 +5952 6 41.2426 8.81864 38.1104 -4.47266 -7.82466 24.3448 +5953 4 41.0373 8.41451 38.9755 -2.01902 1.52645 -10.1427 +5954 4 41.1368 9.75783 38.3095 7.23604 3.04516 -5.74389 +5955 6 53.3619 29.0937 24.5785 -40.2757 11.297 7.14485 +5956 4 52.5565 28.5537 24.7901 26.871 10.2044 -0.818821 +5957 4 52.9453 29.9599 24.3491 20.4755 -15.9472 -3.03 +5958 6 54.9044 15.544 40.7081 25.545 -57.3548 17.1629 +5959 4 54.9892 16.405 40.3633 -12.4948 43.2864 -12.4113 +5960 4 54.018 15.2891 40.9908 -7.57666 14.2468 -5.0348 +5961 6 46.3994 17.0672 31.8767 -6.245 16.1286 -17.5712 +5962 4 46.5114 17.9797 31.5283 3.34232 -11.2714 9.55259 +5963 4 45.8128 16.6602 31.1996 2.74349 5.02824 21.6551 +5964 6 36.898 25.0477 23.0493 11.3229 21.4084 -39.4528 +5965 4 37.2029 24.9737 23.9235 7.13326 -1.42781 43.2733 +5966 4 36.3025 24.3424 22.8486 -15.8402 -9.5757 6.36085 +5967 6 11.3692 4.41343 15.9249 15.7896 22.4119 -17.7964 +5968 4 11.3725 3.62473 15.3598 -3.28732 1.6252 14.2587 +5969 4 11.7055 5.11941 15.3214 -6.01385 -9.48847 12.8461 +5970 6 12.7845 7.07125 19.464 -10.6801 6.56169 22.7508 +5971 4 12.8604 6.27981 18.9655 14.1597 -21.8558 -24.6024 +5972 4 12.2771 6.71627 20.2197 6.8185 19.6013 -8.61559 +5973 6 12.0681 33.6471 17.5522 -1.52085 -17.496 -42.1785 +5974 4 11.9445 34.1189 18.3508 -6.25092 12.897 34.2466 +5975 4 12.5251 32.8183 17.7704 2.9394 6.95993 4.68875 +5976 6 10.2419 4.74292 2.55933 22.7613 10.361 1.71337 +5977 4 9.42389 4.50476 2.9876 -9.73314 -9.75152 7.74431 +5978 4 10.9687 4.12007 2.82053 -14.8261 2.90481 -11.2179 +5979 6 4.58785 36.8771 12.1606 -7.79451 -50.5455 -28.0593 +5980 4 4.4315 37.6675 12.6216 -0.588552 45.9766 17.7929 +5981 4 5.40236 36.9214 11.6472 0.781205 5.58305 7.99313 +5982 6 30.7591 35.3322 25.8391 -38.6972 -6.70904 -25.8809 +5983 4 31.308 35.3014 26.6139 2.09136 -3.6723 11.5509 +5984 4 29.8922 34.8696 26.0006 25.0535 4.09477 3.57125 +5985 6 20.1826 7.15897 1.87495 42.3449 13.1453 -15.8992 +5986 4 20.9155 6.54161 2.14653 -26.0098 16.5163 -6.36728 +5987 4 20.7109 7.92751 1.4772 -24.8109 -25.5601 12.7141 +5988 6 21.7554 6.89613 28.9929 -8.55274 -2.37394 -9.1913 +5989 4 22.0764 7.2366 29.8207 3.60587 3.07422 19.5812 +5990 4 22.5251 6.52709 28.5653 7.82832 -0.878326 -6.51175 +5991 6 6.87782 37.1389 6.94163 -1.13334 10.8563 13.3375 +5992 4 7.36847 37.9928 6.7949 -15.2779 -15.8129 7.53623 +5993 4 6.56156 37.0941 7.87645 12.8328 8.43507 -22.3513 +5994 6 37.1951 18.3599 16.3051 31.8484 54.3956 -63.0636 +5995 4 36.5686 18.6502 16.9278 -28.3708 4.63663 38.6073 +5996 4 37.3394 19.2548 15.8115 -3.93301 -42.965 18.1753 +5997 6 52.3874 25.498 31.3134 14.111 8.09505 3.74503 +5998 4 52.2596 26.4307 31.6656 16.8187 -33.1452 -9.3176 +5999 4 53.3531 25.244 31.2999 -24.6813 13.8962 6.4969 +6000 6 3.93514 39.8328 16.38 27.5969 -10.0907 -6.6773 +6001 4 3.11618 39.8354 16.8714 -5.56329 -11.6849 3.14974 +6002 4 4.25813 38.8985 16.2148 -16.7217 35.1377 3.93655 +6003 6 26.055 14.6352 18.3097 2.48745 23.0231 -5.4837 +6004 4 27.0121 14.5315 18.422 -4.58232 5.3017 0.111087 +6005 4 25.8831 15.6122 18.2324 0.591934 -25.1482 1.36918 +6006 6 22.1861 39.625 23.6336 -13.0035 -7.16992 22.0669 +6007 4 22.5756 40.4198 23.3178 20.0241 20.7615 -16.9022 +6008 4 21.775 39.9577 24.4575 2.36146 -17.5943 -7.81238 +6009 6 5.9827 12.8747 22.3739 5.28791 3.19174 -0.347139 +6010 4 6.16079 13.1981 21.4813 -0.557605 -0.80783 -0.954564 +6011 4 6.85402 12.6686 22.7296 5.64669 -4.60509 -1.11135 +6012 6 48.9358 28.1656 34.7093 -34.12 -15.1013 -7.57113 +6013 4 48.3009 27.4712 34.4428 -1.24475 21.7165 7.07681 +6014 4 49.7483 27.6911 34.6564 33.1581 1.27133 3.59264 +6015 6 7.76665 22.4378 33.2356 5.82113 4.36953 2.134 +6016 4 7.99414 22.0593 34.0982 -2.05459 -3.4103 -7.93698 +6017 4 7.15982 21.8587 32.7652 -2.05153 -2.03416 7.79212 +6018 6 41.0903 39.5994 11.7192 28.8485 25.6095 5.96672 +6019 4 40.6961 40.3697 11.3388 -29.9964 5.48828 -17.7316 +6020 4 41.854 40.0697 12.1081 -2.33823 -21.5528 5.66509 +6021 6 26.8801 37.922 39.3457 -9.67122 -13.15 30.7983 +6022 4 27.1418 37.9976 40.2903 -3.7646 7.48977 -14.0985 +6023 4 25.9915 37.5069 39.4007 11.6973 7.1772 -10.1587 +6024 6 16.8317 41.5399 16.7862 15.0313 6.40425 17.7164 +6025 4 17.5506 0.178386 16.4567 -5.24562 -1.69226 -13.3924 +6026 4 17.0965 41.4441 17.7156 -14.9292 -9.12078 -7.2801 +6027 6 19.02 8.9948 17.6728 1.01249 -20.0254 27.6053 +6028 4 18.8256 9.92734 17.8397 -2.50665 -0.780218 3.94781 +6029 4 19.0722 8.45531 18.5284 1.63313 22.2167 -34.6872 +6030 6 31.0993 24.379 20.1031 -5.45136 7.30173 -0.0135243 +6031 4 30.58 24.6604 20.88 7.69136 -4.59203 -13.2888 +6032 4 31.7465 25.0718 19.9526 0.652083 2.88804 -0.364555 +6033 6 24.6121 6.3117 27.596 -14.2942 3.47042 8.51555 +6034 4 24.6855 6.72112 26.7154 0.000835906 -11.6728 3.52597 +6035 4 24.4562 5.35726 27.5796 2.29956 0.742888 -9.80031 +6036 6 11.6309 5.33579 8.21245 48.3472 17.5789 -13.0214 +6037 4 10.7447 5.097 8.35577 -43.9811 -8.24091 9.59422 +6038 4 11.6324 6.14291 7.66014 -5.62825 -15.0071 6.92232 +6039 6 16.4828 34.2339 17.2467 58.9453 43.3211 -11.1422 +6040 4 15.833 34.737 16.7643 -22.9367 -4.06405 -2.05249 +6041 4 17.323 34.8225 17.0684 -41.083 -49.3458 15.3182 +6042 6 40.7431 40.4645 8.52128 12.2314 -11.8005 -21.5431 +6043 4 40.0246 40.6751 9.09883 -14.9736 5.2464 12.3608 +6044 4 40.4244 39.6664 8.05294 5.87539 10.603 6.78918 +6045 6 42.7463 5.87875 14.2877 12.74 -3.29305 -3.26541 +6046 4 42.0588 5.87807 14.9272 -15.1719 8.11415 20.4154 +6047 4 42.5132 5.11812 13.7588 -0.0411089 -3.23222 -11.0769 +6048 6 14.3659 21.065 6.06718 -46.5802 14.1632 25.7131 +6049 4 14.5381 21.6726 6.80844 -4.55135 -9.99097 -5.53618 +6050 4 15.2049 20.8313 5.76105 45.2018 -10.2131 -22.6687 +6051 6 16.2987 37.772 18.1217 -43.41 26.7654 24.2454 +6052 4 15.4242 38.2299 18.3727 36.2216 -25.3097 -28.3843 +6053 4 16.6845 37.7048 19.001 13.5629 -5.49997 -6.41318 +6054 6 40.7915 27.7152 27.1158 9.45156 2.81801 -4.91689 +6055 4 41.5456 27.319 27.566 -3.53201 -5.16081 10.0516 +6056 4 41.2155 28.2976 26.4751 -4.07016 3.79859 -1.40954 +6057 6 44.9595 25.9846 14.0499 3.3218 -15.4841 -8.79479 +6058 4 45.329 25.1566 13.6433 -5.22711 26.2877 13.1546 +6059 4 45.4837 26.7406 13.7529 4.37393 -9.76715 -6.45081 +6060 6 2.62066 33.9505 21.2427 -16.9582 -3.86849 -3.69815 +6061 4 2.06211 34.7496 21.3041 9.37305 -3.74186 4.79914 +6062 4 2.1388 33.3568 20.6382 5.47892 10.3925 4.65279 +6063 6 5.77806 4.43691 12.8378 4.70319 28.9306 -8.8144 +6064 4 5.36233 3.72198 13.3221 -5.81749 -8.58488 4.20714 +6065 4 5.80863 5.24637 13.3804 -1.3041 -13.5761 2.8333 +6066 6 16.8665 5.92021 7.40582 23.56 -3.08178 3.03829 +6067 4 16.4354 5.08697 7.20958 -2.89912 -12.7512 -7.28137 +6068 4 16.1638 6.54304 7.4701 -21.737 13.5702 4.65232 +6069 6 17.8259 38.4084 36.8446 -8.45971 28.6621 19.1884 +6070 4 17.7005 39.3712 37.0468 11.155 -18.7052 -15.1769 +6071 4 18.5325 38.3077 36.2071 4.43545 2.51623 -4.89916 +6072 6 43.3084 20.5973 5.4325 -39.7754 20.35 -2.23031 +6073 4 43.0204 21.5105 5.15286 19.9417 -23.843 3.70329 +6074 4 42.4274 20.1471 5.43024 22.0601 -2.53082 1.71294 +6075 6 21.5318 23.3 30.4444 10.3709 20.0389 -42.3415 +6076 4 21.0369 22.9394 31.1576 -20.9289 -4.03021 22.2109 +6077 4 20.911 23.6578 29.7428 10.7798 -15.246 22.7192 +6078 6 0.249866 28.0345 36.1724 -10.1983 37.6035 -27.6546 +6079 4 1.05324 27.7572 36.576 20.3102 -14.8665 16.9966 +6080 4 0.540234 28.832 35.6712 -10.982 -12.5736 6.41543 +6081 6 3.04754 17.0516 11.5683 -6.97145 7.64509 -15.3824 +6082 4 3.16434 17.3061 12.4746 3.36597 -0.550097 20.9912 +6083 4 2.52404 17.7798 11.2137 2.91457 -3.72579 -4.7217 +6084 6 24.1788 37.0366 23.9551 -12.9856 4.64226 12.2764 +6085 4 23.6099 37.826 23.831 6.85326 -8.75197 5.00341 +6086 4 24.4012 36.9865 24.9175 -1.53567 3.17074 -21.6248 +6087 6 3.95494 20.5134 27.4915 2.8093 53.7214 17.1103 +6088 4 3.58105 20.0931 26.7551 -14.7022 -26.8908 -38.8522 +6089 4 3.8118 21.4686 27.2477 5.25372 -20.6261 11.8203 +6090 6 54.8404 2.77723 29.6182 19.2518 19.5174 31.7291 +6091 4 54.8688 2.43537 30.559 -2.71579 12.5717 -24.6672 +6092 4 0.596183 3.44189 29.5911 -17.1059 -25.2514 0.407437 +6093 6 27.1931 8.41834 31.7378 -5.45838 77.4793 -29.1542 +6094 4 26.7872 8.25949 30.8671 -2.01983 -12.8877 1.93898 +6095 4 27.4107 9.43311 31.6496 -7.24897 -56.0438 21.5563 +6096 6 30.967 1.65521 30.3853 -24.4372 0.252197 19.6085 +6097 4 30.699 0.824835 30.0215 -2.04196 -23.8902 -26.6583 +6098 4 30.1085 1.94064 30.7387 6.28416 6.26069 6.0985 +6099 6 26.4053 36.4472 36.8445 23.7132 4.61357 6.55265 +6100 4 26.2095 35.8808 36.1068 -5.45287 -5.64468 -12.8873 +6101 4 27.3732 36.593 36.8324 -14.4493 2.44748 -3.93886 +6102 6 51.2993 10.0458 21.7014 24.6671 -30.2423 2.93053 +6103 4 50.7417 9.318 22.0589 9.26734 22.884 -6.07289 +6104 4 52.1551 9.59094 21.4448 -31.6711 18.7199 5.84467 +6105 6 52.4308 12.3792 23.2584 -6.42579 27.1004 22.8118 +6106 4 51.6946 13.0394 23.3088 16.6887 -7.91574 -6.77392 +6107 4 52.0327 11.5757 22.9611 -11.4365 -20.1199 -14.9439 +6108 6 9.99751 38.3699 20.6117 28.0449 -1.18219 -11.795 +6109 4 9.42862 38.2366 21.3654 -6.81781 0.619005 12.6857 +6110 4 10.9196 38.1916 20.8926 -11.789 -1.89114 -3.31064 +6111 6 22.7111 33.2651 0.632604 -8.26324 25.0772 17.5737 +6112 4 23.6702 33.3984 0.628432 0.752102 -10.2993 -4.51528 +6113 4 22.4939 32.4115 0.275412 2.14165 -18.6843 -11.1325 +6114 6 14.0859 40.8716 25.4956 -8.46488 1.55142 -11.4693 +6115 4 14.0599 40.7138 26.4427 12.1567 0.227551 5.06398 +6116 4 13.2623 40.45 25.1949 6.8133 8.32038 -2.55804 +6117 6 42.7734 15.0947 14.9538 14.4784 5.50426 -3.8277 +6118 4 43.0583 15.7694 14.2817 -8.42225 -24.0175 22.033 +6119 4 41.8405 15.2241 15.1238 -9.70916 3.613 0.791575 +6120 6 30.2327 7.231 8.54228 -3.22532 10.2874 -46.9304 +6121 4 30.2058 8.2102 8.45082 -0.363858 -13.9116 11.7844 +6122 4 30.4404 6.92219 9.39771 6.32383 2.81905 38.5597 +6123 6 3.37293 19.847 41.3038 28.0406 -0.792001 0.268463 +6124 4 3.19157 19.2836 40.5407 -0.0866071 4.98821 -2.30354 +6125 4 4.34764 20.0104 41.227 -24.6382 -4.50526 4.46777 +6126 6 8.87233 25.1482 17.2024 12.9182 -25.3276 -29.7935 +6127 4 8.99656 24.7585 16.2934 -10.9438 23.5455 20.5923 +6128 4 9.70028 24.8859 17.6216 -4.47076 0.166054 9.91948 +6129 6 9.34357 14.9539 22.0324 -26.1912 3.45279 3.87325 +6130 4 9.00509 14.8035 22.9321 4.97494 4.93375 -7.4516 +6131 4 10.1685 14.4775 21.9786 8.71262 0.391972 2.49596 +6132 6 2.03472 4.77693 20.8549 -5.0231 -16.4156 -4.2241 +6133 4 2.70086 5.4497 20.9192 18.9425 7.91266 2.94425 +6134 4 1.28907 5.15394 21.3146 -15.2358 3.90158 4.43282 +6135 6 18.286 7.04631 3.85489 -3.97091 0.415968 51.7005 +6136 4 18.7541 7.10917 3.04736 31.918 9.65669 -29.8899 +6137 4 18.8529 6.48913 4.44789 -12.6499 14.6692 -9.5202 +6138 6 17.0004 19.1661 19.8445 11.8294 -6.56912 -12.2376 +6139 4 17.7808 18.891 19.3473 0.445698 5.6808 3.33406 +6140 4 16.3387 18.5282 19.5337 -1.78106 12.0244 12.6463 +6141 6 4.30992 6.55322 21.357 27.1319 -4.11604 -15.0588 +6142 4 4.37542 6.91771 20.4543 -7.8574 5.76294 11.3657 +6143 4 5.24976 6.29093 21.5457 -28.1422 4.34799 0.417434 +6144 6 20.7778 36.9247 35.6618 12.7574 4.02765 2.49936 +6145 4 20.2864 37.0887 34.8562 -7.2468 0.0429553 -2.15645 +6146 4 20.2346 36.372 36.2389 -2.87094 1.27188 3.61263 +6147 6 4.73067 15.0203 31.2359 -10.2649 -12.7571 22.9725 +6148 4 4.37694 14.8342 32.1428 11.1861 -2.73027 -21.4712 +6149 4 4.72677 15.9733 31.1768 1.84417 11.2425 -7.2724 +6150 6 2.35535 1.23403 17.5726 17.2813 12.9738 -21.7174 +6151 4 3.03402 1.36527 16.8495 -17.2186 -13.1695 22.3246 +6152 4 1.92973 2.10387 17.6452 0.590267 -7.80147 9.6411 +6153 6 34.6252 31.5686 19.7984 -1.60729 -4.66139 0.568696 +6154 4 34.8929 31.9422 18.9439 4.49305 -5.18782 4.12596 +6155 4 34.4714 32.3271 20.3758 -2.9002 2.23803 -3.07041 +6156 6 24.1913 21.6089 13.5036 44.4004 0.328862 15.9674 +6157 4 25.0757 21.8297 13.9142 -30.8821 -6.11275 -18.7564 +6158 4 23.5519 22.0563 14.035 -11.4749 15.2668 7.23318 +6159 6 37.218 41.0972 5.69166 19.5034 -37.5651 -15.7416 +6160 4 37.88 41.7374 5.923 7.59407 13.6828 5.23653 +6161 4 36.3807 41.3769 5.99879 -24.6171 21.3167 5.70938 +6162 6 8.42841 7.99247 20.2345 27.9918 -33.0924 -23.0682 +6163 4 9.34968 8.06233 20.5347 -4.8675 5.92304 8.61954 +6164 4 7.93058 8.66586 20.633 -20.9635 39.4709 23.1164 +6165 6 14.934 18.8758 36.75 17.7625 18.3313 11.0559 +6166 4 14.0949 19.1945 36.41 0.856939 4.31409 -3.77921 +6167 4 15.6034 19.6084 36.7133 -18.5855 -12.9909 -4.44137 +6168 6 43.9791 40.6449 18.6524 7.41508 -0.428335 24.9958 +6169 4 43.9624 40.7544 17.7052 -3.16787 6.2189 -16.8328 +6170 4 44.8981 40.8188 18.9384 -9.62798 -9.77666 -5.30663 +6171 6 33.7986 32.259 37.3472 -15.5926 9.65631 -28.1821 +6172 4 34.0274 32.2295 36.4014 -5.19534 3.83485 15.8105 +6173 4 34.1945 31.4931 37.7276 18.2887 -12.3889 13.4194 +6174 6 5.09973 29.2834 24.0252 13.8314 -2.01249 29.2407 +6175 4 5.66693 29.5091 24.8044 -5.06459 -6.54793 -18.8628 +6176 4 4.76417 30.1245 23.7257 -5.49348 12.2693 -6.11875 +6177 6 33.6015 36.4179 10.971 30.294 2.53226 6.78363 +6178 4 32.7735 36.2836 10.5343 -15.5054 6.45725 -2.01925 +6179 4 33.4383 36.5424 11.9099 -7.56878 -2.98124 3.33663 +6180 6 28.3001 33.6166 13.1114 -3.16981 -41.1231 7.22112 +6181 4 27.986 33.7275 12.219 -4.10441 9.98298 -8.29397 +6182 4 28.0891 32.6746 13.2632 10.0083 14.4728 2.55385 +6183 6 6.1623 19.0624 24.2873 5.31394 -11.2621 -36.8053 +6184 4 5.95503 19.8074 24.8143 -4.51254 28.8134 22.7686 +6185 4 6.28788 18.3114 24.8476 4.1007 -18.6743 20.2695 +6186 6 28.4211 19.9362 1.86305 -4.43245 7.71948 8.08869 +6187 4 28.5604 19.4518 1.05094 6.94613 -11.0067 -8.65768 +6188 4 29.2593 20.0693 2.30859 5.46778 1.78077 -4.74455 +6189 6 42.0505 23.9714 9.55892 6.22877 26.0941 -5.00732 +6190 4 42.391 23.8165 10.4395 -2.03908 -8.00084 11.8727 +6191 4 41.7886 23.1541 9.15249 -7.7641 -22.6922 2.79783 +6192 6 43.5253 7.315 27.4414 4.48568 -18.9578 -0.168547 +6193 4 42.7359 7.07504 27.9388 -6.2009 1.74131 6.88183 +6194 4 43.2052 7.88335 26.7439 -2.31843 16.2411 -9.46916 +6195 6 20.4956 32.9945 9.25625 -63.2008 -2.41398 62.3431 +6196 4 19.7614 32.7323 9.96384 46.0698 -1.29529 -42.5223 +6197 4 20.3338 33.9485 9.24422 8.88758 3.29294 -12.4302 +6198 6 38.0318 35.2729 15.9427 -5.10059 -23.3836 -5.94715 +6199 4 37.3995 34.9842 15.2568 2.89047 3.01243 8.00796 +6200 4 37.9835 34.6007 16.6396 -2.13864 4.37071 -5.14357 +6201 6 47.5248 20.8808 3.95546 13.1177 31.1209 27.8573 +6202 4 48.0834 21.3954 3.36869 -6.69878 -8.89675 -13.1919 +6203 4 47.6052 21.4353 4.7772 -13.2785 -23.1226 -13.8569 +6204 6 10.9875 31.6892 41.4239 15.5099 5.40423 7.74084 +6205 4 11.658 31.8708 40.7529 -4.12469 -5.30401 -0.84079 +6206 4 10.1343 31.6927 40.9879 -7.96504 0.77506 -5.12071 +6207 6 43.245 12.6563 2.56138 15.9633 -17.8577 -2.60545 +6208 4 42.9226 12.9752 3.38765 -12.1061 12.2594 19.7928 +6209 4 43.9805 12.0851 2.8659 -6.2276 8.95994 -12.8364 +6210 6 49.4104 25.4124 21.1593 7.68799 -7.2912 5.83542 +6211 4 50.1422 25.2884 20.5387 -8.96396 0.548785 -4.3756 +6212 4 48.9554 24.5515 21.2297 -0.219253 8.20777 -2.75058 +6213 6 1.96484 34.1377 26.4635 6.42117 -7.58108 12.8955 +6214 4 2.78995 33.6488 26.6876 -20.6965 7.00883 -11.752 +6215 4 1.22498 33.5087 26.4121 8.61724 -1.18295 0.134997 +6216 6 17.1337 20.8362 36.6743 -37.6695 15.6036 21.8376 +6217 4 16.9634 21.7284 37.0778 2.65776 -21.0237 -14.9647 +6218 4 18.0617 20.7108 36.604 32.6572 -5.60583 -3.13187 +6219 6 36.5992 10.9735 3.70439 10.6975 8.82737 -5.2901 +6220 4 35.7369 11.4094 3.76988 -2.71865 -0.136466 14.5734 +6221 4 36.9547 10.7712 4.57736 -11.0261 -1.49358 9.11508 +6222 6 14.2213 20.6732 21.973 14.9521 39.3927 -42.8738 +6223 4 13.9206 20.2439 21.1689 -11.1282 -8.72354 1.45028 +6224 4 14.6851 21.4628 21.5779 -7.13343 -24.0966 22.8635 +6225 6 33.9052 12.2539 9.56536 64.6676 -19.1083 -72.943 +6226 4 34.3898 11.482 9.88615 -11.1791 5.59008 13.1859 +6227 4 33.2619 12.5422 10.1406 -48.1209 12.4396 55.8498 +6228 6 21.8075 41.4938 2.15247 -4.53434 0.170379 -15.7872 +6229 4 22.04 41.6038 1.2069 -3.47083 0.972349 16.0219 +6230 4 22.4007 40.8419 2.51679 12.4955 -1.6466 3.58022 +6231 6 20.9241 10.4413 14.2084 23.7182 11.537 17.3335 +6232 4 21.6155 10.8692 14.7979 -25.0251 -17.572 -17.464 +6233 4 20.772 9.54041 14.5736 6.4121 16.6732 -7.22543 +6234 6 6.25992 4.45494 24.6446 -20.993 10.5392 9.58783 +6235 4 6.70633 4.20365 23.8452 17.869 -10.7134 -15.0213 +6236 4 5.71116 3.71075 24.9084 -2.77077 -5.20552 -8.90983 +6237 6 50.776 14.5967 23.4784 31.7068 8.96229 10.5861 +6238 4 51.3012 15.0259 24.1918 -10.5702 -1.89466 -14.6802 +6239 4 49.902 14.4731 23.8252 -15.4415 -8.6063 7.51113 +6240 6 52.7906 13.9066 9.67243 -4.11462 48.2741 -4.64476 +6241 4 52.8606 13.0389 9.99278 3.823 -46.6932 12.5875 +6242 4 51.8698 14.0585 9.47707 -15.983 -0.946523 -10.048 +6243 6 9.04475 2.0467 29.9184 -38.5307 -30.621 -19.1189 +6244 4 9.46565 2.82007 30.2002 17.3321 39.2201 17.0183 +6245 4 8.08016 2.26538 29.8177 25.0495 -3.86709 2.38687 +6246 6 7.14389 29.9898 26.2407 4.70582 -42.771 12.4286 +6247 4 6.53112 30.404 26.8495 -5.08686 4.52864 3.1398 +6248 4 7.41427 29.1442 26.7142 -2.42767 26.6911 -17.7681 +6249 6 49.1638 41.7413 14.3375 -4.64089 27.4779 2.19815 +6250 4 49.5241 41.3828 13.5134 1.94418 -6.50091 1.47491 +6251 4 49.3811 0.802946 14.3236 2.14399 -30.2019 -5.07663 +6252 6 5.64888 3.82667 19.1906 -2.72189 -11.1411 26.1263 +6253 4 5.18678 3.36179 19.9258 5.23606 10.5823 -14.7259 +6254 4 5.05621 3.82399 18.4509 -7.60985 1.79477 -11.7277 +6255 6 9.32681 35.8274 24.8975 3.55565 13.5922 8.51546 +6256 4 10.2018 35.8152 24.4762 -3.06017 -4.39849 2.56743 +6257 4 9.46171 36.417 25.6586 -3.66837 1.49938 -3.23358 +6258 6 53.0285 29.7558 11.5499 -7.83487 -2.48558 9.64451 +6259 4 53.3653 30.4407 10.9686 7.5475 4.44921 -4.95089 +6260 4 52.7971 30.2083 12.3783 3.5824 -3.07517 -4.75195 +6261 6 22.6104 9.96627 5.67467 11.8622 1.90434 48.3765 +6262 4 23.3836 10.3266 6.15809 -8.36646 -10.9093 -7.81297 +6263 4 22.6398 10.3769 4.83333 -6.21393 7.91547 -32.804 +6264 6 39.5293 19.6134 2.67969 28.3515 9.20962 14.5311 +6265 4 38.5781 19.5068 2.58618 5.24604 -11.8744 -9.9137 +6266 4 40.0367 19.3939 1.87869 -17.6459 -1.04308 -3.70363 +6267 6 45.0742 35.5802 7.80399 12.9966 -1.00157 -13.6899 +6268 4 45.1073 36.2582 8.46111 4.45786 22.5875 10.9896 +6269 4 44.5296 34.9182 8.21469 -15.7495 -15.8794 0.100297 +6270 6 29.7829 14.2459 9.96531 -11.2509 -10.5838 -6.95263 +6271 4 30.0063 14.1556 9.0247 4.7074 -2.26926 1.20969 +6272 4 28.8478 13.9409 10.004 20.3358 11.6689 4.42407 +6273 6 29.2532 30.1489 21.8872 -22.7358 8.41186 19.7293 +6274 4 29.1261 30.8351 21.2312 3.02893 4.58934 -9.48892 +6275 4 30.0577 29.6729 21.7506 17.9631 -9.68935 -13.2514 +6276 6 11.1028 18.8149 6.56446 12.6172 11.1172 -5.75863 +6277 4 11.2898 19.7306 6.3073 -12.9819 2.38317 -1.53669 +6278 4 11.9922 18.4416 6.57196 0.724871 -8.7617 2.86424 +6279 6 13.403 39.1446 13.4748 19.5871 -11.9429 -30.0571 +6280 4 13.7697 39.8507 13.9939 7.8117 10.5151 13.4831 +6281 4 12.6292 38.8582 13.9386 -20.2152 -7.12839 8.32373 +6282 6 50.1432 12.9893 0.138872 33.4511 24.3017 64.4039 +6283 4 49.8497 12.6921 41.2405 -20.6967 -26.8999 -59.7452 +6284 4 50.7523 12.3231 0.503203 -9.52656 2.062 -3.94446 +6285 6 47.8312 31.3446 27.7846 -28.8076 12.8422 -13.2841 +6286 4 47.8833 31.94 28.5222 10.4006 4.03183 17.8143 +6287 4 46.9755 31.6479 27.4044 17.0933 -18.1054 -4.43643 +6288 6 27.7087 1.63781 7.50008 21.5285 -7.57238 -25.6841 +6289 4 26.9556 1.59549 8.05597 -25.0455 5.22958 17.9803 +6290 4 27.5166 0.963037 6.82134 -2.90509 7.89899 -0.0646572 +6291 6 54.8922 20.8 16.0331 4.1789 -41.4982 -7.93337 +6292 4 54.9282 20.9554 16.9716 0.186425 8.83729 15.9831 +6293 4 0.211633 19.8495 15.948 -9.91253 29.0383 -5.43741 +6294 6 37.4291 33.0056 34.4398 -14.0977 10.8622 -7.94924 +6295 4 37.2978 32.0826 34.6133 -1.58878 -21.6351 7.1631 +6296 4 36.5764 33.2755 34.0173 17.7258 4.45123 10.3439 +6297 6 19.5104 39.7742 6.7506 5.90241 -38.4201 -4.61078 +6298 4 19.1293 39.2182 6.01225 10.8403 19.9531 16.5545 +6299 4 19.9162 39.0938 7.35425 -12.9804 24.3225 -11.3083 +6300 6 32.4399 2.72699 8.06906 17.0773 23.4006 1.78158 +6301 4 32.9347 3.14941 8.81642 -19.9733 -16.2934 -9.37408 +6302 4 31.5531 2.49842 8.37658 0.516726 -6.41942 5.39598 +6303 6 12.9757 16.0915 4.06618 3.48233 -26.1302 -11.2272 +6304 4 12.5744 15.6527 4.83433 -0.695682 4.00385 -3.98901 +6305 4 13.3513 15.3473 3.55621 -4.30287 11.2057 5.6128 +6306 6 4.64677 29.9233 5.42983 -10.8182 14.2385 -56.8973 +6307 4 4.99957 30.1958 4.52107 -6.90737 -7.02982 36.161 +6308 4 3.86081 29.3683 5.18005 29.0195 11.7205 17.0104 +6309 6 29.7541 32.1122 24.0662 13.5325 13.0696 7.67536 +6310 4 30.657 32.2311 24.4313 -14.6232 -5.62961 -5.85099 +6311 4 29.8358 31.5529 23.3009 -2.99915 -14.1964 -7.88188 +6312 6 11.8689 30.6971 33.4711 -8.01032 -39.2081 28.7873 +6313 4 11.8961 29.8478 34.0479 -0.904256 41.1124 -29.4381 +6314 4 12.7288 30.7703 33.0546 6.62137 -3.78113 1.33903 +6315 6 17.3676 40.4123 27.3051 45.9752 30.8726 -27.1152 +6316 4 17.3095 41.3718 27.4557 -2.78012 -6.90788 -0.219066 +6317 4 16.6513 39.9873 27.6906 -54.0346 -15.2197 27.4879 +6318 6 8.66734 4.89901 8.93063 6.14116 -5.58058 -4.6479 +6319 4 8.35347 5.40804 8.18272 -1.2331 1.82325 -6.13974 +6320 4 8.16334 5.22925 9.67691 0.199365 1.34734 7.84993 +6321 6 39.5604 17.6833 9.57201 22.5105 -50.1639 -23.667 +6322 4 39.2658 17.6048 10.464 -10.5204 8.51393 23.2154 +6323 4 39.725 16.7168 9.31019 -10.6666 45.7312 -1.86495 +6324 6 31.4955 30.1755 28.5516 10.628 -19.507 17.1882 +6325 4 32.3525 30.3948 28.1778 -6.71462 8.32315 -8.11857 +6326 4 31.74 29.3729 29.0438 -14.9082 5.37925 -0.357203 +6327 6 52.6685 19.2672 40.0663 9.25056 16.4026 -20.0757 +6328 4 53.0106 18.7322 39.321 -9.61724 -4.6138 17.4516 +6329 4 53.0677 20.1385 39.8955 -5.74465 0.792691 -1.74468 +6330 6 3.24164 7.81666 9.85998 28.0429 9.66948 1.15728 +6331 4 3.83019 8.53432 10.2304 -23.9275 -17.8293 -12.7584 +6332 4 3.84853 7.29279 9.3074 -9.38214 5.4782 3.90821 +6333 6 23.129 35.218 35.5945 -25.4929 1.01472 15.9258 +6334 4 23.7784 35.3391 34.9359 33.2897 3.00284 -24.4901 +6335 4 22.5015 35.9398 35.4197 -4.85807 -5.03855 8.29984 +6336 6 19.51 14.0653 20.8221 -35.7596 -3.44758 -1.61502 +6337 4 19.8587 14.4985 21.6011 13.4146 6.44294 7.16022 +6338 4 18.5274 14.0852 20.9637 18.4505 -1.93413 -5.69736 +6339 6 23.6205 15.8624 24.0207 6.44012 -27.6666 -1.73497 +6340 4 23.7023 16.8084 24.0387 5.71305 22.1977 -2.17526 +6341 4 24.4604 15.4749 23.6823 -15.4387 15.2983 3.34328 +6342 6 0.280487 30.496 6.10097 2.10248 14.5258 38.6463 +6343 4 54.969 30.1752 5.28655 -5.78718 -18.1599 -43.8305 +6344 4 54.4568 30.8162 6.51538 2.11893 2.60892 6.09244 +6345 6 4.88818 13.213 29.1211 -10.1066 -44.834 -24.7823 +6346 4 4.81121 13.8494 29.7943 -5.77674 34.7781 35.8081 +6347 4 5.65875 13.4519 28.6173 14.302 5.76116 -10.624 +6348 6 54.2113 27.2762 19.1921 -15.5686 -30.3542 31.9917 +6349 4 0.068746 27.3681 19.6083 11.8738 0.793184 4.88761 +6350 4 54.2438 27.8077 18.4285 0.565084 22.1088 -37.313 +6351 6 13.9147 35.7477 9.19539 -9.45761 -42.0549 -30.4782 +6352 4 13.6498 35.0288 8.53341 12.0253 23.1831 27.3793 +6353 4 13.9217 36.5134 8.63033 3.91359 16.7787 -6.83247 +6354 6 5.91895 31.9062 18.8199 -10.5522 26.6577 -12.1166 +6355 4 5.59368 32.8276 18.7738 -3.70357 -9.82177 15.0022 +6356 4 6.3357 31.8271 17.9661 5.53766 -12.0386 -9.76018 +6357 6 5.80079 28.8629 9.48582 -4.23387 2.66619 -7.91216 +6358 4 5.1492 29.3316 10.0156 -4.194 3.81529 3.65919 +6359 4 5.26808 28.2356 8.96551 5.75879 5.11243 0.385299 +6360 6 40.1186 6.06288 9.7252 27.6823 -14.9678 -34.8134 +6361 4 40.0604 6.61837 8.91786 -4.97866 -6.72317 19.9534 +6362 4 40.8451 5.41953 9.46609 -26.5422 19.2978 14.9684 +6363 6 20.3249 13.4665 41.4109 48.5393 0.491453 -34.6424 +6364 4 21.248 13.7047 41.7262 -35.6043 -9.97545 -2.58991 +6365 4 20.4078 13.625 40.4256 -17.6073 -2.89865 23.6593 +6366 6 14.4355 21.7431 27.3521 26.8888 -5.93952 12.1752 +6367 4 15.3929 21.7238 27.5426 -15.4302 4.65814 3.66232 +6368 4 14.4086 21.5632 26.4128 -6.38145 3.02673 -3.91912 +6369 6 38.7552 1.80385 30.0529 11.0268 -28.3612 -27.359 +6370 4 38.4475 1.96331 30.9218 -11.1335 10.8767 32.3314 +6371 4 38.864 2.66369 29.6567 5.01485 14.1269 -3.82072 +6372 6 5.6038 10.8537 14.1812 -8.02182 -19.6512 10.0037 +6373 4 4.967 11.5707 14.1035 -3.71772 1.30399 -2.93081 +6374 4 5.11243 10.0991 14.6 11.6474 17.9462 -13.8385 +6375 6 45.4185 36.7135 27.9228 -18.8199 18.417 -42.2307 +6376 4 46.0687 36.7087 28.6222 8.21134 6.27257 3.16342 +6377 4 45.7172 37.2784 27.1471 -3.80026 -24.227 32.4306 +6378 6 54.0799 35.0377 20.3974 -0.144446 0.236923 -11.8112 +6379 4 53.8476 34.1116 20.536 0.519878 -4.41527 -2.37245 +6380 4 53.9532 35.2077 19.4441 0.866973 -0.817495 13.7238 +6381 6 42.0671 14.221 28.4749 -2.16655 -3.30611 3.54679 +6382 4 41.9442 13.9043 29.3971 9.00113 8.16851 -11.079 +6383 4 42.9986 14.4434 28.31 -2.56617 -4.72525 9.98454 +6384 6 34.845 7.68802 26.7053 1.50556 20.2543 7.34306 +6385 4 35.7046 7.39142 27.0344 -1.60005 -9.47728 3.59716 +6386 4 34.4934 7.05976 26.0702 4.4346 -10.8207 -3.70702 +6387 6 49.6605 30.7141 23.8514 -28.5275 -6.56067 -11.9374 +6388 4 50.4604 31.1934 23.8565 34.1351 17.5516 -0.640456 +6389 4 49.8146 29.9659 24.4072 5.37992 -19.8924 15.651 +6390 6 50.8948 7.80148 14.1671 21.5777 -12.9452 34.2787 +6391 4 50.8247 6.96775 13.7105 -4.99079 -12.0182 -18.7136 +6392 4 50.5655 8.51894 13.6572 -15.7049 17.9748 -24.3233 +6393 6 4.26893 39.4826 27.8512 8.9926 -8.51629 -1.47833 +6394 4 3.65831 40.2241 27.8513 -3.04259 7.34368 5.94949 +6395 4 4.00328 38.958 27.1013 -12.9816 -10.5728 -11.1653 +6396 6 8.75177 32.8341 8.22283 -21.5639 -30.1985 -34.1316 +6397 4 8.2383 32.1284 7.72694 10.6374 17.547 21.6449 +6398 4 8.83279 33.5372 7.56693 3.76401 9.53239 7.06969 +6399 6 52.9594 25.4882 9.38297 -25.0802 50.1357 20.0056 +6400 4 51.9882 25.4292 9.65119 35.7509 1.27265 -17.7678 +6401 4 53.158 26.4759 9.49827 -6.53976 -44.9947 -5.62964 +6402 6 29.5661 36.7256 19.4603 5.44621 -17.3757 32.4066 +6403 4 29.5786 37.3961 18.7906 9.88328 7.74732 -15.4263 +6404 4 30.4565 36.6309 19.8726 -14.3545 4.38723 -10.5986 +6405 6 52.3236 36.1013 25.1169 17.8415 -25.8683 -35.0149 +6406 4 52.9656 35.7372 25.71 20.0999 5.67458 7.00157 +6407 4 51.6595 36.4261 25.6714 -35.904 19.3861 23.0835 +6408 6 21.182 15.7103 31.1872 -18.8583 3.19523 -20.0756 +6409 4 20.6533 16.2005 30.5215 19.2403 -4.60119 13.454 +6410 4 20.518 15.2243 31.6931 2.46505 1.20146 2.10658 +6411 6 10.6569 22.4337 39.4531 2.51655 -26.4213 -37.4968 +6412 4 10.8327 22.4219 38.4645 -4.29248 9.16844 28.2769 +6413 4 10.2506 21.5589 39.6181 7.08653 12.2011 0.686531 +6414 6 25.1113 11.6729 22.7164 -12.9971 -0.576423 -18.0399 +6415 4 25.1382 11.4787 23.6279 21.2779 0.00518046 39.517 +6416 4 24.1824 11.5118 22.5586 2.84555 -0.272219 -17.8246 +6417 6 31.7896 10.4703 2.90217 -23.2712 -10.1944 -9.79051 +6418 4 32.6146 10.7499 3.28348 13.8778 6.97942 -8.99307 +6419 4 31.8394 10.4464 1.92418 10.0551 5.29594 18.2662 +6420 6 52.4849 36.4361 22.1663 -9.62786 -33.6069 5.21212 +6421 4 53.146 36.0606 21.5474 -12.5852 0.946736 4.3316 +6422 4 52.0694 35.6392 22.6209 17.7505 30.3514 -16.202 +6423 6 46.2093 40.0329 26.9877 0.0297183 29.9961 33.6049 +6424 4 46.4751 39.2742 26.5126 9.55695 -26.8643 -22.4205 +6425 4 45.9048 40.7092 26.3771 -3.76152 -2.91476 -3.34389 +6426 6 24.0885 36.7218 39.1011 7.12362 -3.16907 -4.80429 +6427 4 23.5999 35.9078 38.9667 11.8985 -11.6148 -5.9332 +6428 4 23.4559 37.2234 39.5891 -11.7402 16.6095 17.3029 +6429 6 22.3514 7.42547 31.8169 -35.2707 -41.8068 15.3628 +6430 4 22.2213 8.33277 32.0647 5.94025 21.3422 4.40196 +6431 4 21.6465 6.92073 32.3398 32.1745 21.6054 -24.7594 +6432 6 14.3502 18.3597 4.09728 -2.0055 -9.38358 23.348 +6433 4 14.1099 17.4219 3.93107 -0.92654 19.6042 10.3569 +6434 4 14.0726 18.5364 5.03654 13.0175 -10.3464 -23.9346 +6435 6 27.3175 38.46 0.124188 33.1007 -9.911 1.68747 +6436 4 26.9395 39.2806 0.463932 -4.88512 2.40457 5.81864 +6437 4 28.2608 38.413 0.45438 -35.2324 2.96259 -2.16122 +6438 6 18.6695 0.162292 12.2239 -43.166 1.81748 26.3235 +6439 4 17.7303 0.262878 12.5713 26.4571 2.30278 -22.2908 +6440 4 18.9433 41.3202 12.7499 8.63834 -11.46 6.42912 +6441 6 49.423 24.9792 25.3382 20.605 1.42964 -0.346179 +6442 4 48.5484 24.7002 25.6009 -12.613 -0.556076 -3.92373 +6443 4 49.3508 25.8032 24.8352 -9.8769 -5.62219 -3.2466 +6444 6 52.0685 20.2858 15.7446 -45.9435 -8.75518 14.7384 +6445 4 52.9731 20.5149 15.783 39.268 6.79994 2.42829 +6446 4 51.7449 20.2597 16.6676 4.81444 3.79951 -9.92674 +6447 6 49.6576 15.6472 38.4942 19.425 -17.6129 -0.00729052 +6448 4 49.2099 16.0165 37.7231 -6.98596 1.36616 -1.50856 +6449 4 49.5102 16.1958 39.2633 -14.7214 13.7889 5.58845 +6450 6 15.9211 23.7235 13.4193 23.3289 -36.8815 11.3263 +6451 4 16.506 23.7025 14.2147 -19.633 8.70021 -19.3267 +6452 4 15.5217 24.5725 13.2813 -7.62789 19.6624 11.7876 +6453 6 14.3566 29.1635 14.3074 -12.0826 22.9902 -11.8551 +6454 4 14.1263 29.6193 13.4563 6.10678 -19.1115 21.2229 +6455 4 14.1254 29.8374 14.9735 4.9154 -5.66101 -4.10969 +6456 6 30.4264 19.8612 16.8883 21.8822 -42.1222 -1.02119 +6457 4 30.7186 19.5182 17.7453 7.89699 4.38367 -1.56912 +6458 4 29.8579 20.5689 17.0557 -25.7709 36.069 4.20145 +6459 6 21.3137 21.0352 23.1207 17.1515 -0.95565 24.203 +6460 4 22.2175 21.149 23.495 -16.5785 2.35003 -9.75668 +6461 4 20.7278 21.0809 23.8918 1.9436 3.71589 -4.02445 +6462 6 32.3543 0.425745 25.2542 2.91189 -3.53517 -15.1456 +6463 4 32.2281 0.339162 24.2978 10.7775 -1.18886 4.59452 +6464 4 31.5305 0.792307 25.5362 -21.0885 6.89421 14.2132 +6465 6 26.144 32.4145 27.5224 1.5207 15.2147 0.716215 +6466 4 25.5792 33.1636 27.3089 1.00017 8.92672 2.49827 +6467 4 25.8737 31.7446 26.908 1.40169 -15.6227 -12.5261 +6468 6 31.6924 23.0038 41.4488 2.9891 4.25247 18.5975 +6469 4 32.5817 22.7219 41.7427 -10.6129 2.19465 -7.80737 +6470 4 31.0787 22.7203 0.234806 2.54762 2.31931 -6.22567 +6471 6 54.3675 17.8383 10.7129 6.79577 23.0573 52.4548 +6472 4 53.55 18.2477 10.4428 -14.1319 6.62767 -11.4304 +6473 4 54.6119 17.1874 10.0964 4.54612 -26.2874 -33.1105 +6474 6 15.4111 28.5567 8.624 -23.5209 17.7221 -14.2225 +6475 4 14.7074 29.0083 8.07604 23.4242 -18.2482 9.63627 +6476 4 15.9053 27.9212 8.07642 -10.4486 8.35345 -4.07335 +6477 6 21.923 22.3267 27.6697 4.39763 -15.072 3.90508 +6478 4 22.0757 23.261 27.7591 9.36727 14.8743 -6.39222 +6479 4 22.0153 22.013 28.5729 -4.02641 -8.91923 4.38679 +6480 6 2.936 17.0367 8.13301 26.8737 -0.816539 -9.93732 +6481 4 3.80704 17.1417 7.69888 -17.5309 -13.2134 -6.39661 +6482 4 2.90872 17.8246 8.6543 -8.08771 15.2208 15.3377 +6483 6 27.578 18.2783 3.98106 42.3665 -21.0645 -7.59535 +6484 4 26.9838 18.9866 3.87461 -35.9411 25.5305 -3.32845 +6485 4 28.3853 18.6252 3.56495 -11.0807 -10.9366 8.58166 +6486 6 24.7671 24.5333 8.4671 -3.55267 7.94183 -11.8318 +6487 4 25.0347 23.6359 8.24775 3.17664 -3.45343 1.13667 +6488 4 24.5725 24.5372 9.40731 3.34714 4.39373 0.466573 +6489 6 41.9868 30.4684 13.7801 28.6364 -21.7839 2.09937 +6490 4 42.9472 30.4515 13.6527 -5.43777 20.4489 -0.76134 +6491 4 41.8419 29.5153 13.705 -23.7897 6.87836 6.63004 +6492 6 15.6883 34.6775 41.5701 28.3539 0.757195 5.77675 +6493 4 16.4499 35.2822 41.5481 -1.40988 -1.74654 9.10263 +6494 4 14.9914 35.2483 41.869 -21.9895 7.57474 1.73196 +6495 6 11.1473 19.7636 40.5906 -7.01786 -3.24743 -12.0486 +6496 4 12.0915 19.8265 40.3679 -7.75233 -10.0339 3.8807 +6497 4 10.7912 18.9088 40.243 10.6872 10.1147 9.9033 +6498 6 47.4955 34.5311 14.2936 14.7321 -31.661 -1.66099 +6499 4 46.9342 35.3117 14.2317 -6.87541 2.2103 -19.2779 +6500 4 47.4978 33.9137 13.4978 -3.14061 27.4792 16.9676 +6501 6 12.3981 26.9866 28.4861 26.5251 -74.1409 -7.08463 +6502 4 13.226 26.8461 29.0045 -10.1246 11.0422 -0.548558 +6503 4 12.3843 26.0988 27.9797 -6.45597 45.1087 15.272 +6504 6 27.6352 16.207 39.8297 -11.2321 14.8168 6.13397 +6505 4 27.2166 15.4175 40.1567 -13.0977 -6.13948 14.8525 +6506 4 28.2209 15.8539 39.184 23.7477 -3.37658 -20.6816 +6507 6 33.4012 31.2187 27.2758 -9.34358 5.5086 -22.6345 +6508 4 34.125 31.7676 27.5967 0.31405 7.14405 -9.79506 +6509 4 32.8978 31.7031 26.5666 21.3968 -7.09575 17.214 +6510 6 39.0983 39.5786 31.9234 0.802497 -2.15341 -0.194752 +6511 4 38.8245 39.6381 30.9898 -0.836727 0.773065 10.2743 +6512 4 38.5517 40.2102 32.4207 8.13236 -5.11153 -2.10971 +6513 6 22.8875 16.5662 19.9556 -18.6429 -47.4181 0.677292 +6514 4 23.2714 15.7467 20.3471 4.73069 19.3315 1.98369 +6515 4 22.0725 16.1814 19.5628 10.6014 14.9969 -2.71875 +6516 6 23.9725 21.8734 10.5896 -27.2099 14.1239 -19.8382 +6517 4 22.9807 21.8764 10.5048 23.1264 -0.860286 11.7265 +6518 4 24.1883 21.166 11.1844 -1.51334 -13.3572 20.4185 +6519 6 40.1791 25.4384 2.79385 3.27033 10.4385 -27.7191 +6520 4 40.1215 24.9503 3.60378 -1.57927 -2.0951 21.761 +6521 4 39.8421 26.3422 2.89187 -4.34677 -6.39915 11.9951 +6522 6 15.0222 19.7637 9.4145 -47.1416 28.5942 15.5409 +6523 4 14.7277 20.7258 9.2944 13.9352 -33.0223 -5.4956 +6524 4 14.1981 19.3167 9.80349 37.3596 11.4933 -12.2096 +6525 6 7.16734 24.8761 0.122492 -38.9593 -14.3052 4.78001 +6526 4 7.92262 24.7355 41.4818 28.9246 2.82935 -8.29154 +6527 4 7.37325 25.3267 0.937782 12.1222 2.94845 5.10402 +6528 6 43.395 10.8961 31.3295 35.6095 27.14 14.9602 +6529 4 43.8689 11.0333 30.4778 -14.9331 -12.4968 13.4948 +6530 4 44.125 11.0026 32.0067 -24.5429 -5.74221 -22.764 +6531 6 13.8447 19.0699 27.8622 -3.35019 15.2359 -6.83255 +6532 4 12.9833 18.7163 28.0985 -4.55464 1.4506 5.93475 +6533 4 13.7874 20.0538 27.8435 3.60016 -14.5834 0.921784 +6534 6 3.48728 19.5892 9.61273 -55.7314 7.48447 -10.4955 +6535 4 2.69835 20.0905 9.96963 22.9021 -19.0673 -4.76373 +6536 4 4.2501 19.9102 10.0538 23.4289 5.03115 15.3445 +6537 6 51.0169 19.4212 7.7195 26.3048 39.1054 -53.7154 +6538 4 50.748 20.2575 7.21364 -2.7273 -32.3506 28.7892 +6539 4 51.8579 19.2204 7.21263 -29.2082 -7.0208 18.9647 +6540 6 42.2149 2.6091 10.4112 25.8935 -20.0624 -18.8025 +6541 4 43.1623 2.45904 10.6444 -24.152 11.2038 4.82319 +6542 4 42.1853 2.33112 9.4647 -3.80011 10.6068 21.7004 +6543 6 30.7928 6.43901 35.1986 -21.6247 -20.8821 1.11778 +6544 4 29.8295 6.39304 35.3716 10.0359 5.79706 -2.44011 +6545 4 31.0478 5.50645 35.0814 0.649811 9.90023 -1.69835 +6546 6 52.8722 36.96 18.5947 9.01539 9.27494 -7.55423 +6547 4 52.0657 36.4448 18.5061 -12.9065 3.13675 2.3407 +6548 4 52.6935 37.8522 18.2226 2.03776 -15.609 7.12003 +6549 6 44.2018 6.29599 1.04883 9.29405 17.1768 7.51252 +6550 4 44.5044 7.06671 1.58929 -4.49779 -17.4812 -0.431191 +6551 4 44.952 6.10526 0.487985 -0.115844 -2.61588 -3.46335 +6552 6 42.1326 38.6047 31.1849 18.5327 -13.3283 33.8135 +6553 4 41.7834 38.9864 30.4106 -14.9936 10.8543 -35.8121 +6554 4 41.4904 38.8324 31.8627 -0.641051 1.33351 1.93 +6555 6 43.7219 12.8013 9.05519 -6.282 7.91343 -40.7352 +6556 4 43.3171 13.69 8.87718 10.3632 -22.6116 8.3507 +6557 4 43.9578 12.415 8.15014 1.61383 14.3586 37.3488 +6558 6 13.4062 0.438838 6.51561 -30.6084 29.4042 -0.600484 +6559 4 12.9719 1.14899 7.05573 20.0807 -17.3818 -8.1595 +6560 4 13.3782 0.782754 5.59696 2.59294 -3.03922 8.63079 +6561 6 16.1217 13.2907 10.2805 -3.10591 -25.3511 -12.454 +6562 4 16.8946 12.7568 10.5076 8.02861 4.25978 2.86397 +6563 4 15.5299 12.6092 9.88546 -0.135156 17.9383 7.81515 +6564 6 1.59113 8.48217 4.69745 0.410151 -22.2633 16.3582 +6565 4 1.97054 9.1194 4.11301 8.92831 16.113 -22.7699 +6566 4 2.26765 8.43533 5.38895 -6.97239 3.0759 6.50405 +6567 6 37.2935 1.72102 10.5172 -13.7439 -9.21578 15.0824 +6568 4 37.1042 2.64553 10.595 10.0955 20.4226 -13.0857 +6569 4 36.8105 1.41855 11.2983 8.13599 -13.5394 -0.658926 +6570 6 53.8411 9.88961 17.6933 -45.7386 -38.9159 3.57486 +6571 4 54.5353 10.0399 17.0846 27.4782 6.59889 -23.5339 +6572 4 53.3721 9.08338 17.329 10.482 22.3983 14.0606 +6573 6 45.4787 30.6173 15.8038 -24.3966 -4.27047 13.1326 +6574 4 44.7717 31.1876 16.1963 22.3351 -9.42651 -10.1125 +6575 4 45.1907 29.6979 15.9324 6.84487 10.052 -2.21901 +6576 6 39.9241 16.6394 33.8426 -26.8877 -6.37158 -14.218 +6577 4 39.1549 17.2016 33.5476 23.291 -18.1751 3.42158 +6578 4 39.818 15.753 33.3934 2.94846 26.4583 15.0268 +6579 6 32.8532 24.7638 27.9368 9.55773 21.8346 -14.3088 +6580 4 33.6229 25.0593 28.4772 -14.6217 4.84572 -15.4057 +6581 4 32.6055 25.4822 27.2751 14.9958 -18.2832 35.5187 +6582 6 7.86628 31.6164 24.1091 22.2934 14.9204 62.1634 +6583 4 7.77595 30.8628 24.7489 -5.82572 16.0022 -25.8365 +6584 4 8.17309 32.3545 24.746 -24.9312 -26.1857 -42.8493 +6585 6 43.5324 41.3356 15.8165 16.5067 -5.02973 0.188395 +6586 4 43.1944 0.320073 15.7896 -5.69638 5.43212 -4.38793 +6587 4 44.429 41.3992 15.443 -10.6291 -2.88383 0.315207 +6588 6 20.021 29.5505 33.1902 25.0419 -7.98688 14.3875 +6589 4 20.8911 29.4069 33.5992 2.6372 -12.3274 -8.42754 +6590 4 19.6576 30.1636 33.8147 -14.9588 14.7065 -0.197692 +6591 6 43.4056 21.4569 18.6265 10.2156 -2.1017 15.5441 +6592 4 43.0498 21.3696 19.5313 -0.699705 -7.60676 -10.3888 +6593 4 42.9844 20.831 18.0298 -12.2248 -1.50447 0.773582 +6594 6 3.43117 19.1215 18.408 34.3393 4.70286 11.768 +6595 4 3.22621 20.0564 18.4267 -2.18643 4.81974 -5.59269 +6596 4 2.60088 18.6799 18.3703 -20.3233 -14.3491 -1.28903 +6597 6 41.6742 38.1112 16.3299 0.384784 -42.0766 -46.2559 +6598 4 41.8939 37.3404 15.6708 -9.75075 44.1094 34.3099 +6599 4 42.3403 38.1083 17.0131 5.25517 -2.87066 6.28124 +6600 6 7.56339 36.3915 10.5048 -18.8567 -13.4705 -13.5944 +6601 4 6.70677 36.1596 10.0967 9.18231 15.0261 0.193132 +6602 4 7.92251 35.493 10.5558 6.04756 10.3771 12.1048 +6603 6 36.2642 19.1103 34.8187 -40.4108 -29.7457 -43.4097 +6604 4 35.4719 19.3187 34.2477 20.3247 -4.92751 27.2967 +6605 4 36.4213 19.8813 35.3193 7.80254 33.8099 20.7293 +6606 6 53.576 24.9483 12.6399 1.20561 -0.517111 -17.326 +6607 4 53.6619 25.9414 12.669 8.79141 -29.2645 -7.24265 +6608 4 53.913 24.5623 11.7782 -4.09912 18.2899 28.1509 +6609 6 31.6824 10.4618 21.0892 -21.9557 -25.3726 -8.81809 +6610 4 31.4281 9.67391 21.5915 5.84781 10.5911 6.7189 +6611 4 30.8909 10.5838 20.5303 11.506 8.60894 0.332243 +6612 6 18.1093 28.7861 17.1823 13.2379 18.2354 -13.1758 +6613 4 19.074 28.7105 16.9739 -24.5165 5.38082 5.29014 +6614 4 17.7652 29.607 16.728 11.5472 -26.6353 13.0333 +6615 6 21.6834 18.2239 36.88 17.2587 0.811675 -5.67627 +6616 4 22.5671 18.027 36.4721 -27.7349 -1.55215 19.1593 +6617 4 21.6367 17.7543 37.7464 -1.70499 5.95625 -12.509 +6618 6 25.0551 19.0348 34.2287 -62.1041 -5.07763 23.2016 +6619 4 24.7663 18.3443 34.8719 5.43786 16.9757 -10.9409 +6620 4 25.8827 18.7578 33.9618 64.2031 -27.8273 -22.1538 +6621 6 15.5709 13.019 5.5539 0.00735057 -17.6807 20.5563 +6622 4 15.9927 13.3293 6.36292 0.0692085 12.4919 -5.39058 +6623 4 15.4491 12.0681 5.73828 -2.05735 13.2604 -17.7033 +6624 6 54.47 41.6402 14.7959 12.609 -13.6787 23.2741 +6625 4 54.8097 41.4531 15.6947 -1.45983 11.4249 -10.5768 +6626 4 53.7709 40.9948 14.7271 -15.6812 0.146288 -8.92901 +6627 6 1.6639 26.4809 31.3827 12.672 -25.15 69.1319 +6628 4 2.55491 26.3764 31.7735 -12.447 -0.333387 -5.00094 +6629 4 1.81595 26.6127 30.4938 10.6163 16.8649 -70.5286 +6630 6 32.3417 37.2868 29.6843 -28.8191 13.9029 5.49332 +6631 4 31.5776 37.8992 29.8843 22.0104 -18.6347 -4.04342 +6632 4 33.1171 37.6855 30.0945 4.79121 1.59444 1.77014 +6633 6 52.7104 21.0422 22.8867 -25.9211 15.4876 17.6965 +6634 4 51.8895 21.5407 22.5959 27.9099 -16.7396 2.24416 +6635 4 53.1785 20.6742 22.1421 1.33026 -7.16251 -14.9349 +6636 6 32.7465 28.5808 40.5193 19.5614 -2.95666 4.13778 +6637 4 32.1272 29.2507 40.2236 -19.1805 -2.02865 5.11045 +6638 4 32.5793 28.3106 41.4408 -7.78706 5.87783 -13.0149 +6639 6 23.6078 32.0654 16.3528 6.52471 10.7856 29.7964 +6640 4 24.3701 32.0729 16.9793 -11.8963 -10.2614 -20.8491 +6641 4 22.8856 32.382 16.9256 -1.99185 -7.37994 -15.8659 +6642 6 37.5296 9.17182 29.9714 -32.9897 5.30306 10.5453 +6643 4 36.7716 8.86544 30.5111 15.5785 -5.70066 -5.7121 +6644 4 37.1221 9.9689 29.5744 15.1662 -5.45151 -1.53858 +6645 6 2.26386 24.3835 14.5546 6.71022 -7.72281 -24.2479 +6646 4 1.85963 24.0133 15.3587 -6.19133 3.33276 -9.20692 +6647 4 2.05254 23.8227 13.7642 -0.610841 12.6744 29.5344 +6648 6 27.3686 28.7935 24.7702 8.50672 -13.2399 -34.495 +6649 4 27.2338 28.4442 25.6457 -6.20833 -8.14759 12.6395 +6650 4 27.3624 28.0447 24.1031 3.25167 21.2409 25.246 +6651 6 16.785 2.54959 14.3094 -6.20571 44.0359 18.8502 +6652 4 17.7332 2.53792 14.3228 12.8455 -14.2273 -3.64568 +6653 4 16.4133 1.8101 13.8617 -1.35631 -25.1723 -17.3636 +6654 6 21.8048 39.8028 36.8143 34.4281 41.1875 6.43987 +6655 4 22.7768 39.6281 36.9504 -24.2083 -5.20947 -5.56999 +6656 4 21.4132 39.0119 36.5213 -11.0202 -42.2818 -12.3994 +6657 6 14.0639 6.48367 41.5586 -1.33856 -25.5903 -39.7582 +6658 4 14.9412 6.10051 41.3922 2.86672 3.38346 15.7648 +6659 4 14.0719 7.05039 0.399753 4.3465 12.2327 22.8772 +6660 6 14.5548 16.5075 9.32956 22.0841 -14.7784 -21.2506 +6661 4 15.3586 16.5914 9.87503 -6.36199 2.72911 -6.08794 +6662 4 13.8899 17.0883 9.65711 -8.71884 14.1475 23.1102 +6663 6 8.67066 23.4815 30.5556 -44.0195 -7.59097 13.7496 +6664 4 9.49671 23.6557 30.1334 33.8338 1.75787 0.0184994 +6665 4 8.69311 23.4014 31.5307 16.0679 1.7618 -7.5699 +6666 6 37.6567 2.07706 19.9993 -10.7882 4.4912 14.9507 +6667 4 36.977 2.26584 19.3592 -1.31755 -8.36894 -24.369 +6668 4 37.311 2.65872 20.6865 17.7477 -2.01295 10.0374 +6669 6 42.7201 7.55732 8.02256 37.7013 -31.8103 68.6738 +6670 4 43.2078 7.90139 7.31041 13.9641 18.3531 -33.1003 +6671 4 43.4713 7.36984 8.74143 -54.3005 13.1784 -34.8973 +6672 6 38.5678 29.6657 6.85728 10.4727 -7.97498 12.0381 +6673 4 38.5138 29.2192 7.70857 5.95943 6.40388 2.63109 +6674 4 37.7242 29.471 6.47402 -15.8477 4.38345 -15.5494 +6675 6 42.5297 15.7017 39.7864 -1.2311 2.72873 2.24862 +6676 4 42.7877 16.6334 39.6476 -7.55712 -4.9727 -7.52807 +6677 4 42.0746 15.3358 38.9963 17.4435 12.5166 7.69263 +6678 6 19.8571 7.43592 22.0545 -24.1472 -5.51637 33.4113 +6679 4 19.2244 8.12179 21.7601 9.35088 -5.78158 -2.10146 +6680 4 19.4596 7.11536 22.9248 14.2781 17.6372 -34.9907 +6681 6 27.4149 3.22069 12.5516 40.9266 14.4549 -35.8463 +6682 4 28.3021 3.29229 12.0821 -30.0356 5.19144 18.8294 +6683 4 27.3767 2.28812 12.7581 -5.67627 -4.82192 6.74426 +6684 6 34.4116 6.50186 34.3661 -21.9879 -4.07114 7.78674 +6685 4 33.6675 7.13398 34.4265 8.52018 -4.33452 -1.60522 +6686 4 34.0848 5.70903 34.842 8.55338 12.1797 -0.556276 +6687 6 9.89342 27.9558 39.7643 36.6491 -8.46867 13.0669 +6688 4 10.8456 28.0225 40.104 -41.9626 -4.51635 -15.7261 +6689 4 9.67004 28.8098 39.3873 2.34979 10.3628 -2.65954 +6690 6 50.5619 22.115 6.39208 17.1303 26.4748 31.0688 +6691 4 51.4904 22.4109 6.45725 -8.74694 -11.3909 -7.00891 +6692 4 50.1939 22.6078 7.15954 -8.62199 -11.7106 -16.757 +6693 6 47.1151 11.4881 30.0373 19.0993 -20.4412 31.5796 +6694 4 47.2481 10.8506 30.7795 8.25865 21.4973 -13.9376 +6695 4 46.3269 11.1564 29.6474 -26.9131 -5.13028 -17.9745 +6696 6 25.9416 28.4741 9.79918 -11.6773 -32.55 32.2578 +6697 4 26.8348 28.2861 10.1548 -13.4597 2.20587 -7.83095 +6698 4 25.3328 27.8368 10.2912 20.3964 27.2145 -12.4741 +6699 6 35.4384 36.5941 19.4416 12.9267 19.1414 22.694 +6700 4 35.4164 36.6623 20.432 -0.885856 -8.21646 -20.3497 +6701 4 36.1159 37.2681 19.2232 -9.51806 -6.29836 -4.59986 +6702 6 39.0948 17.8654 12.2958 16.402 12.2899 -6.89152 +6703 4 39.0474 18.8007 12.5965 -2.38328 -10.6878 -1.40665 +6704 4 38.4419 17.3626 12.7715 -16.1853 0.319976 14.0097 +6705 6 2.67108 27.1436 2.40101 -1.75759 -3.65761 -8.1759 +6706 4 1.9876 27.5644 1.84788 8.2175 -2.76418 4.2561 +6707 4 2.53155 27.392 3.3289 1.87867 -1.67129 -3.85288 +6708 6 12.3359 32.2055 21.5153 -21.7508 0.12991 31.168 +6709 4 12.6488 32.0797 22.4173 29.0853 13.2861 -13.6486 +6710 4 11.491 31.8094 21.7155 -17.148 -0.720271 -25.2422 +6711 6 32.8833 32.3716 8.45599 -19.6455 -21.472 -14.5807 +6712 4 33.4538 32.8256 9.05859 9.48117 21.6574 11.6239 +6713 4 31.9723 32.7028 8.50155 9.17651 3.82723 3.41156 +6714 6 12.6485 6.44458 31.9777 -6.29944 1.49663 15.4125 +6715 4 13.1578 6.35833 31.1835 12.9638 -3.65534 -14.9347 +6716 4 11.7474 6.25334 31.7296 -4.07419 -1.29291 -2.47195 +6717 6 41.3645 27.7433 14.0415 -6.01814 -18.8263 -25.007 +6718 4 41.8124 27.3175 13.2596 -11.5333 15.588 22.1217 +6719 4 40.3975 27.5756 13.9407 20.5065 3.01622 5.4742 +6720 6 6.60161 16.499 25.4489 9.93734 -1.87947 -15.8553 +6721 4 7.35848 15.8951 25.4583 3.3895 5.33583 -1.00098 +6722 4 6.02379 16.0419 24.8253 -6.53341 1.34025 8.2366 +6723 6 21.7786 39.2974 13.3607 -58.7317 27.2846 42.4257 +6724 4 22.3848 39.3902 12.6828 41.4687 -6.70168 -50.5194 +6725 4 21.6228 40.2371 13.624 5.27297 -27.3266 2.34771 +6726 6 34.8408 6.01319 6.94562 -18.4641 -1.51643 5.78804 +6727 4 33.8445 5.90926 6.91888 31.3517 2.57767 -4.40922 +6728 4 35.1545 6.28252 6.0657 -8.54142 -2.93715 0.97402 +6729 6 33.0232 30.4151 33.1713 -30.7469 -3.39927 -39.9685 +6730 4 32.1382 30.6983 32.7963 25.7009 -18.3352 9.36685 +6731 4 33.1108 30.988 33.8978 7.7837 23.494 30.6115 +6732 6 15.4491 32.4129 12.2013 37.3068 -21.1945 16.3611 +6733 4 16.3823 32.073 12.2446 -28.3662 8.39135 1.47263 +6734 4 15.4224 32.8258 11.3561 0.313824 15.5191 -23.5701 +6735 6 12.6648 26.6033 21.3782 33.3074 -46.6123 -64.9668 +6736 4 12.0344 25.8976 21.5501 -12.6652 14.4466 17.403 +6737 4 12.7392 27.3327 21.935 -15.9008 39.2731 46.5109 +6738 6 47.0171 36.3051 29.9756 -14.9097 -3.99946 59.7783 +6739 4 47.3887 37.0247 30.5306 -0.120183 -5.44251 -19.0377 +6740 4 46.4147 35.8463 30.6463 22.302 11.6315 -30.1098 +6741 6 0.299553 12.7005 23.3858 -50.0817 10.3486 20.6993 +6742 4 0.55843 11.8154 23.133 6.9712 -0.709946 -9.28769 +6743 4 54.2783 12.6185 23.429 39.7411 7.62342 -2.706 +6744 6 54.1651 18.9185 21.5773 -27.3575 7.2555 -32.8787 +6745 4 0.055729 18.801 21.8215 42.2187 -10.4087 33.76 +6746 4 54.2632 18.7361 20.6344 -21.3012 2.13243 0.141772 +6747 6 25.7162 24.2884 23.7449 23.2111 -33.139 -2.25213 +6748 4 25.1836 23.5617 23.2944 18.61 24.747 21.927 +6749 4 26.5708 23.8587 24.0884 -36.4232 14.4676 -16.0896 +6750 6 11.8952 29.0236 26.8796 9.31073 -5.31833 9.58593 +6751 4 12.582 29.6684 27.1204 -3.01706 -1.21814 -5.31042 +6752 4 12.0145 28.319 27.5465 -5.16863 11.8863 -12.5997 +6753 6 48.0052 35.8598 10.6996 -18.0426 -22.591 -32.4945 +6754 4 48.7896 35.6794 10.1443 -7.64403 10.0758 9.7343 +6755 4 48.2747 36.3464 11.4544 19.4818 11.8303 20.3364 +6756 6 47.6544 29.8545 36.9555 47.7155 -39.8456 -42.9298 +6757 4 48.1196 29.373 36.1789 -16.9409 17.9192 43.9777 +6758 4 46.9556 30.2951 36.4995 -17.6283 12.0501 3.0439 +6759 6 7.32865 12.3513 10.6225 -20.3459 13.1064 -14.334 +6760 4 7.20572 12.8267 9.76478 7.03806 -14.4953 16.449 +6761 4 6.49136 12.5857 11.0944 24.1086 -12.0498 -8.15528 +6762 6 52.9256 15.9641 4.89737 -18.3283 -2.7411 -11.4996 +6763 4 53.001 16.1105 3.94443 2.36662 -0.713792 8.85774 +6764 4 53.8018 16.0105 5.25645 21.1817 2.44507 8.14275 +6765 6 10.6731 16.9472 34.6118 -36.7423 -4.99845 -47.4494 +6766 4 11.0533 16.8484 35.4724 -5.12202 -12.2675 26.0308 +6767 4 9.83371 16.4151 34.3796 40.245 18.7583 25.5995 +6768 6 25.147 31.0596 36.0152 -5.60145 -19.7687 -32.0201 +6769 4 25.7935 31.7656 36.1171 1.22463 2.78419 -3.72446 +6770 4 25.3418 30.5949 35.1615 -4.38154 15.6016 24.1358 +6771 6 34.0913 21.8858 41.4775 -4.76405 18.1665 32.5634 +6772 4 33.6625 21.1007 41.1787 -2.29922 -28.5955 -6.85504 +6773 4 34.6054 22.1733 40.7506 14.2114 10.2598 -30.2937 +6774 6 15.7731 30.0818 1.26798 39.0641 -13.3599 -49.0464 +6775 4 15.0823 30.4241 1.791 -23.818 19.5269 30.6537 +6776 4 16.2108 30.862 0.84325 -15.3415 -19.24 18.755 +6777 6 29.5302 27.8609 16.6022 -41.3972 -29.0796 28.0786 +6778 4 29.3307 26.8764 16.753 17.6765 42.2449 -1.67193 +6779 4 28.8227 28.3009 17.156 20.6394 -5.21731 -15.3441 +6780 6 39.6438 9.77612 0.552706 9.07327 13.2864 29.0584 +6781 4 40.129 10.5839 0.897097 -15.1313 -20.9808 -12.8857 +6782 4 39.4906 9.23066 1.36029 2.34479 9.54176 -15.0004 +6783 6 1.51524 31.8825 16.4089 -15.0842 0.567558 32.708 +6784 4 2.11225 32.2249 15.7721 17.5465 17.6302 -23.3114 +6785 4 1.56386 30.9485 16.2687 -0.663138 -25.5376 -6.36093 +6786 6 8.73078 39.8635 25.0545 2.96185 -34.7465 -17.9129 +6787 4 8.00321 39.5602 25.6169 4.07363 9.59654 5.53067 +6788 4 8.89391 40.7829 25.2096 -1.06312 24.7623 5.36493 +6789 6 42.3301 10.2778 9.76455 0.0249942 22.0437 -8.66619 +6790 4 42.035 10.1947 10.6715 6.68889 -4.55788 7.04955 +6791 4 42.6957 11.1854 9.68656 -1.85544 -15.7885 0.75259 +6792 6 13.241 7.61416 1.95847 -11.6175 -6.73398 30.6404 +6793 4 13.9892 7.82191 2.54806 -1.36929 5.6022 -7.80568 +6794 4 12.5695 7.22502 2.56499 11.7798 7.16895 -16.7116 +6795 6 18.7434 40.0583 14.2212 10.8937 -7.32712 21.4541 +6796 4 19.2417 39.7541 15.0131 -1.99408 15.6159 -18.1773 +6797 4 17.935 39.549 14.2832 -4.44855 -3.57314 -3.37042 +6798 6 20.0977 14.0454 38.5561 35.4799 -67.417 -7.49733 +6799 4 20.2641 13.632 37.67 -9.31749 10.6865 24.2255 +6800 4 19.7827 14.877 38.3297 -23.7972 64.5272 -8.60678 +6801 6 22.6565 28.8842 34.0588 -5.52315 8.37947 20.7951 +6802 4 23.0585 28.228 33.4828 2.77778 -4.34029 0.307399 +6803 4 22.9395 28.703 34.9822 0.354749 -6.57221 -14.6515 +6804 6 22.6874 4.70198 5.2328 -25.042 -9.90055 15.5414 +6805 4 22.1274 3.9708 5.56882 12.1557 -0.0327816 -16.8284 +6806 4 22.5434 5.31639 5.94822 12.9551 16.3877 4.62095 +6807 6 23.6492 33.9942 38.3998 23.375 33.8394 -43.1733 +6808 4 22.8011 33.6715 38.57 -44.227 -25.7371 21.164 +6809 4 23.4749 34.4069 37.5183 19.103 -7.547 16.6445 +6810 6 48.374 21.3549 17.2744 -0.727013 41.2048 -23.9838 +6811 4 48.2041 22.3166 17.0448 3.0192 -25.1475 26.0409 +6812 4 48.3509 20.9743 16.3868 -2.31832 -8.94154 10.8829 +6813 6 11.5758 10.9938 8.63273 -18.0621 42.8191 15.9647 +6814 4 11.6313 10.2483 9.25156 -2.19238 1.01339 1.87179 +6815 4 11.0547 11.7764 9.03291 21.9333 -36.8133 -6.7089 +6816 6 40.0924 28.1686 33.4857 17.1635 -5.37387 30.2378 +6817 4 41.046 28.3881 33.5354 -13.2006 -3.32107 -11.2861 +6818 4 39.7443 28.4933 32.6629 4.51627 6.28126 -11.3213 +6819 6 47.3837 25.6703 5.29617 28.7657 21.9065 -4.48206 +6820 4 46.461 25.5322 5.12569 -20.8862 2.51482 -4.893 +6821 4 47.6179 26.6114 5.08959 -12.3293 -15.1007 -0.275896 +6822 6 21.6517 35.2222 23.996 27.7917 10.3485 -3.89698 +6823 4 21.6311 34.5383 24.6593 -10.5502 -12.8786 6.64496 +6824 4 22.5954 35.4881 23.9966 -15.7417 2.23004 -2.6139 +6825 6 8.24409 41.4919 8.41354 9.22969 12.4334 -12.8549 +6826 4 8.15 40.8674 7.67873 -1.07657 -2.81584 5.48771 +6827 4 7.83543 41.113 9.18983 -1.52095 -3.2343 5.88405 +6828 6 16.4798 31.1082 22.2131 -4.24513 -17.8742 -2.35359 +6829 4 17.0752 30.8161 21.5077 -7.18137 4.28218 -7.0656 +6830 4 17.0564 31.1902 22.9696 5.97679 -0.907857 10.4567 +6831 6 54.7122 0.459271 28.3177 -16.7834 -37.5181 -6.57119 +6832 4 0.641958 0.15455 28.3975 4.09167 16.1916 -1.73275 +6833 4 54.5379 1.34634 28.6236 20.797 14.6923 4.72985 +6834 6 48.4477 15.3762 4.17752 -7.35125 -30.0531 -4.44848 +6835 4 49.1738 15.1128 4.81019 -14.8803 0.337287 -24.8229 +6836 4 48.0902 14.5922 3.6288 23.2827 31.0113 24.8784 +6837 6 34.3541 7.00171 40.4295 26.6588 -46.9533 -23.8625 +6838 4 33.6168 6.99428 39.8319 -14.4938 10.2897 -3.98371 +6839 4 34.9839 6.35967 39.9588 -19.3291 28.4488 24.7248 +6840 6 41.3507 3.37676 17.0028 -19.6969 -26.4955 -6.96819 +6841 4 41.02 2.66518 17.5936 5.53648 12.9859 -1.78552 +6842 4 41.944 3.90566 17.5305 10.5068 9.85924 8.73726 +6843 6 48.4427 20.685 14.5419 46.8112 -36.6841 26.4704 +6844 4 48.0177 21.3487 14.0717 -32.7597 47.8552 -32.6818 +6845 4 49.3877 20.9188 14.5227 -9.08294 -4.43462 -1.64124 +6846 6 52.4922 28.1277 37.1182 6.87418 8.84651 -10.3419 +6847 4 53.4134 28.4024 37.0408 3.12987 -6.6922 4.15316 +6848 4 52.2752 27.8963 36.2007 -7.47166 7.06161 9.73328 +6849 6 53.8774 18.5638 18.79 -18.2161 -77.5341 7.0005 +6850 4 54.7018 18.1425 18.5274 3.76082 -0.315502 -3.76089 +6851 4 54.0435 19.4528 18.7445 16.4561 77.5259 -2.54699 +6852 6 41.0011 39.1407 28.7879 -31.3786 -4.09579 71.7092 +6853 4 41.3911 39.2094 27.9661 28.9736 8.71878 -68.6315 +6854 4 40.0521 39.3021 28.7019 -2.27612 -3.41331 -6.23213 +6855 6 38.2743 8.75074 24.2285 24.5029 -7.68366 -19.8132 +6856 4 39.1919 8.60362 23.8621 -28.3827 4.68959 18.7737 +6857 4 38.3545 9.42009 24.9092 0.456349 2.35846 11.2764 +6858 6 2.99111 29.1615 9.6319 43.2691 -54.6401 14.341 +6859 4 2.5338 28.6319 8.99687 -12.0219 1.86489 -18.3516 +6860 4 2.58318 29.9865 9.638 -27.8835 49.5023 8.75508 +6861 6 27.5756 29.2755 18.3378 -4.01048 -11.7045 41.1881 +6862 4 26.7643 29.1652 17.8389 -11.7278 -2.11582 -9.62984 +6863 4 27.2839 29.0037 19.2864 20.9622 13.2114 -52.0932 +6864 6 11.8501 21.1733 10.1172 4.58733 -51.566 26.4002 +6865 4 12.2099 22.0246 9.9906 13.4732 33.828 -10.0235 +6866 4 12.4495 20.7458 10.776 -15.5727 16.0367 -15.8372 +6867 6 16.9004 32.2989 0.299881 0.133752 -22.2186 -6.7835 +6868 4 17.7029 32.7095 0.626455 9.4749 11.3588 3.4417 +6869 4 16.2118 32.9605 0.285394 -3.66285 20.1796 -4.1714 +6870 6 1.30064 17.4766 22.5523 32.9941 -5.4384 -19.965 +6871 4 1.2446 16.5356 22.2294 -6.1018 21.6977 3.5382 +6872 4 2.22906 17.8023 22.3815 -23.7878 -13.737 8.2324 +6873 6 41.5474 6.85538 29.3077 15.2611 30.5857 3.861 +6874 4 41.7413 5.96016 29.5642 -1.91107 -14.5726 0.121693 +6875 4 42.0251 7.37916 29.9826 -12.8279 -1.76094 -5.06557 +6876 6 10.5087 10.782 13.8577 27.0965 -13.6956 13.3978 +6877 4 10.7007 11.2274 13.0253 -2.16043 3.73872 -7.98734 +6878 4 11.2742 10.169 14.0479 -24.5023 11.0776 -3.5626 +6879 6 39.8289 15.4978 40.8346 25.2099 1.13818 0.661387 +6880 4 40.0487 16.0673 40.0758 -9.90377 -2.84048 2.34508 +6881 4 40.6829 15.4254 41.3222 -18.4618 6.82556 -4.74882 +6882 6 26.5164 19.6052 40.5088 -9.33805 1.61856 -11.7217 +6883 4 27.41 19.9717 40.4897 0.274496 -7.70925 5.49567 +6884 4 26.4209 18.9712 41.2422 6.64723 7.57269 5.06511 +6885 6 54.036 8.18782 13.7715 27.5212 34.9045 -2.54262 +6886 4 54.5316 7.46918 14.1378 9.61628 -19.3806 0.327355 +6887 4 53.1925 7.88218 13.5309 -39.9219 -15.1658 -7.5943 +6888 6 15.6949 25.3434 10.6718 -31.7842 -7.37099 0.0612328 +6889 4 15.1805 25.3333 9.84403 14.6699 1.30202 -4.92807 +6890 4 14.9666 25.3615 11.3188 15.8696 -4.15214 -3.47235 +6891 6 18.5987 3.44175 21.9294 71.7321 -9.69418 15.9409 +6892 4 19.6071 3.44542 22.1959 -64.1569 1.8736 -14.3483 +6893 4 18.6296 3.58776 20.9721 -7.77871 5.49431 4.81248 +6894 6 50.8883 20.6265 18.5187 28.1172 41.6529 17.9746 +6895 4 50.1573 21.1733 18.1958 -9.23125 -9.06144 -4.34911 +6896 4 51.4834 21.2842 19.0045 -23.468 -29.5191 -15.1667 +6897 6 53.3673 20.9038 31.2869 -12.1652 -1.18869 -3.23134 +6898 4 53.2409 20.9073 32.2442 5.88471 -1.70994 -0.407299 +6899 4 52.4717 20.8062 30.9053 11.2743 1.61965 3.90294 +6900 6 52.8102 27.6189 28.9831 -34.4743 -7.30027 30.0453 +6901 4 52.2848 27.4362 29.7987 1.4862 0.901255 -27.4551 +6902 4 53.4947 28.1361 29.3473 35.4934 25.3811 1.80223 +6903 6 33.3112 15.6955 11.3264 12.7704 9.00306 37.7013 +6904 4 33.4999 16.1238 12.2198 -3.00415 -23.4283 -28.8796 +6905 4 32.4346 16.0003 11.1059 -7.33456 8.94646 -4.12361 +6906 6 20.3875 26.8057 27.4813 21.213 -4.31231 15.2493 +6907 4 19.6396 27.3594 27.2578 -2.8557 9.66202 -0.370116 +6908 4 20.9667 27.2946 28.1279 -24.4059 -13.8952 -19.2793 +6909 6 8.54399 2.06163 14.1713 4.36483 17.1543 -0.299448 +6910 4 8.13837 1.20516 14.196 -9.47708 -17.773 2.17407 +6911 4 8.01805 2.60085 14.7902 6.78451 -6.83093 -3.12033 +6912 6 40.1002 7.56575 40.6778 12.4019 9.60944 38.6013 +6913 4 39.712 8.14959 41.3779 4.03526 -4.70584 -30.6789 +6914 4 40.8329 7.16354 41.1893 -8.78874 -6.51591 -16.4763 +6915 6 6.89044 6.83556 10.7869 16.1514 15.8461 -3.23426 +6916 4 7.31622 7.70217 10.5979 -16.164 -15.6489 3.8938 +6917 4 7.04178 6.69918 11.735 -3.2221 -0.411834 -4.21297 +6918 6 31.2643 6.58983 20.136 22.5576 -57.6677 6.94967 +6919 4 30.6637 5.92034 20.5005 -2.47046 2.78164 8.35653 +6920 4 30.7152 7.30056 19.9711 -35.0351 52.1138 -11.6241 +6921 6 54.5411 21.0454 27.2925 4.1013 -43.0328 84.8338 +6922 4 0.071192 20.2129 27.5399 -15.6737 30.1382 -21.2093 +6923 4 54.6532 21.3072 26.4181 12.1035 8.54749 -60.3726 +6924 6 4.75213 23.1508 16.2245 -49.4139 4.34438 -28.0546 +6925 4 4.2471 24.0009 16.1592 20.3634 -17.2761 5.59937 +6926 4 5.4972 23.3136 16.7675 27.2932 5.42097 22.4316 +6927 6 25.5515 11.0241 14.8358 9.2665 0.546345 5.2197 +6928 4 26.0976 10.3608 15.3182 -9.73323 12.0118 -14.516 +6929 4 25.8683 11.8947 15.1133 0.0398252 -5.90721 -2.6003 +6930 6 41.1974 41.7784 29.942 -27.7855 -7.97533 -10.6302 +6931 4 40.9203 40.8727 29.6366 8.3922 29.767 6.72032 +6932 4 40.4023 0.465719 29.8931 18.9924 -15.525 2.17149 +6933 6 52.2793 15.2936 41.6313 19.4314 -9.06844 -20.2837 +6934 4 51.991 15.9601 0.331443 -10.9307 10.9541 10.4228 +6935 4 51.6032 14.6231 41.5544 -13.8311 -6.7739 0.824233 +6936 6 37.7418 21.7882 37.8505 9.73059 24.2058 3.49681 +6937 4 37.8176 20.8655 37.6583 6.26781 -24.8638 0.142384 +6938 4 38.1128 21.8753 38.7352 0.661952 0.248137 2.40564 +6939 6 23.8436 9.73697 27.5598 -17.3101 -56.824 -21.1542 +6940 4 23.6823 8.97924 26.8635 13.0753 42.6322 38.797 +6941 4 23.3674 9.48178 28.3892 6.27388 8.11738 -19.7561 +6942 6 43.0121 28.0431 32.8137 29.5034 -18.022 1.83467 +6943 4 42.9555 27.148 33.1715 -16.7807 6.42622 4.12236 +6944 4 43.9561 28.0675 32.5908 -15.6612 14.0802 -2.62256 +6945 6 34.1451 21.2362 11.9042 -10.4207 -39.0944 -3.26361 +6946 4 33.7785 20.3444 12.1585 8.75301 27.3815 0.918114 +6947 4 33.7383 21.3833 11.0382 -2.92284 10.3561 2.31655 +6948 6 10.5016 31.8267 10.0873 5.91889 6.7472 5.74276 +6949 4 10.9186 32.6594 10.3946 -11.2895 -14.4825 -9.55855 +6950 4 9.99233 32.0033 9.274 9.03923 7.50024 8.93884 +6951 6 35.8744 37.1309 22.1208 9.07655 -0.20125 -37.6945 +6952 4 36.7757 37.5102 21.9868 -16.2539 -8.14962 7.83623 +6953 4 35.5893 37.243 23.0078 -0.963312 7.56509 34.0991 +6954 6 27.293 4.59192 27.4599 -62.9251 -2.97268 8.43797 +6955 4 27.8573 4.63875 28.2367 1.75868 -0.322614 6.7695 +6956 4 26.3027 4.46726 27.7774 60.9698 2.85981 -12.9146 +6957 6 39.0165 22.2861 10.6525 -25.2911 9.99335 20.5692 +6958 4 39.5938 21.9801 9.97437 16.8498 -5.94336 -19.6369 +6959 4 38.1468 22.3658 10.2352 2.38909 -7.32087 0.337973 +6960 6 30.765 39.1813 10.9358 -26.8864 17.0789 0.421318 +6961 4 31.7273 39.1993 11.0368 0.254075 -10.0442 -6.8497 +6962 4 30.3957 38.288 10.8473 24.5485 -0.522695 0.476538 +6963 6 44.5972 26.9475 2.20695 17.6159 -27.9211 -0.145864 +6964 4 44.8477 26.0903 2.61727 -13.9349 20.2639 -7.87324 +6965 4 45.3006 27.0404 1.55025 0.322606 15.9 1.66232 +6966 6 23.7817 14.549 26.4845 -13.1218 37.1912 -28.6876 +6967 4 23.5085 15.1786 25.7375 18.3344 -26.327 26.4977 +6968 4 23.2314 13.7794 26.3439 -3.10125 -8.02717 6.138 +6969 6 38.3349 13.3785 39.6531 51.0719 11.8768 18.627 +6970 4 39.1134 13.8424 40.1004 -28.3003 -20.0613 -21.9332 +6971 4 37.637 14.0102 39.7945 -20.9869 -1.09015 1.55638 +6972 6 17.9076 17.2343 29.3998 2.5182 -11.8623 9.07057 +6973 4 17.7005 16.8028 28.5679 -0.208052 -3.06359 -6.42367 +6974 4 17.2973 17.9612 29.4206 -13.3644 14.2602 6.84169 +6975 6 17.427 29.8312 9.9167 5.70667 9.14636 11.5297 +6976 4 16.5259 29.8398 9.63655 -18.5043 -5.93208 -2.5299 +6977 4 17.9097 29.6705 9.11934 16.3543 -3.78316 -10.6623 +6978 6 35.6302 6.05705 19.6249 -12.632 -1.17761 -30.1407 +6979 4 35.1756 5.57436 18.904 4.12491 -0.359791 14.6292 +6980 4 35.7342 6.9119 19.1826 9.40393 1.91765 12.7562 +6981 6 18.674 22.2857 17.523 8.42296 3.39096 21.1197 +6982 4 17.7402 22.4481 17.6821 -9.17854 0.615652 -6.61815 +6983 4 18.8674 22.3747 16.5992 -7.41694 3.44878 -20.9034 +6984 6 20.0258 3.81405 32.2871 -5.45876 10.2161 0.982716 +6985 4 19.684 4.03807 31.424 -2.67861 3.00481 -7.64614 +6986 4 20.9375 3.54321 32.099 -1.59169 -5.33194 9.42598 +6987 6 5.47094 6.98417 8.10987 -1.95658 -27.204 5.03178 +6988 4 5.85072 7.84658 8.088 3.96324 28.039 -6.11929 +6989 4 5.94584 6.55919 8.82772 -3.50663 -6.33739 10.9422 +6990 6 44.182 20.5312 25.5979 43.1361 -13.705 -19.148 +6991 4 44.6875 21.1042 26.1493 -15.9255 27.6084 29.7698 +6992 4 44.9726 20.2272 25.1253 -26.0739 -14.4287 -20.9555 +6993 6 43.9621 36.9892 17.8709 27.7049 17.1418 -9.42399 +6994 4 44.6647 37.4643 17.3692 -13.724 -4.61297 12.4448 +6995 4 43.6121 36.3808 17.225 -14.1002 -14.0328 0.985329 +6996 6 34.6183 10.1148 16.2555 -4.96303 14.2933 -37.1542 +6997 4 34.4099 10.1014 15.264 7.63186 -7.52385 38.4141 +6998 4 34.6455 11.0716 16.4378 1.03434 -4.81203 3.48645 +6999 6 23.6535 3.43617 1.32551 9.32991 -27.0385 -60.023 +7000 4 23.5361 2.47498 1.09872 1.70789 26.2755 24.74 +7001 4 23.8607 3.79652 0.414552 -11.3127 6.44054 37.9529 +7002 6 33.4225 38.9606 5.09116 -45.0556 15.9463 14.7537 +7003 4 32.9187 38.171 4.91655 10.2233 -24.4058 -4.43744 +7004 4 32.6531 39.5198 5.39063 34.9247 3.3662 -8.43025 +7005 6 22.5542 32.508 35.8091 -1.62577 21.6885 -22.4452 +7006 4 23.4313 32.1432 35.8321 13.5304 -8.64793 9.08541 +7007 4 22.6972 33.4304 35.4917 -7.91418 -12.6316 15.6694 +7008 6 32.4209 37.2696 13.8263 22.6153 37.4816 -15.7005 +7009 4 31.6314 36.8608 13.5507 -35.0264 -17.3769 -13.0658 +7010 4 32.7321 36.7183 14.5153 12.3601 -27.6025 17.2047 +7011 6 52.6048 12.7515 39.5965 -13.8302 -6.28036 -1.32475 +7012 4 53.26 13.3571 39.2655 9.70847 9.80763 -6.22213 +7013 4 53.0114 12.2827 40.3245 7.10516 -3.61819 3.538 +7014 6 28.8284 14.5654 1.23244 38.3097 18.383 -14.9432 +7015 4 28.2834 13.8143 1.34735 -23.3809 -22.0338 3.15251 +7016 4 28.3672 15.33 1.56727 -9.74512 0.414323 3.22557 +7017 6 1.45359 32.4205 23.3989 -1.05001 -40.1011 -18.1189 +7018 4 1.47013 31.5606 22.9188 -1.41837 10.7967 19.8874 +7019 4 1.97354 32.9442 22.8182 11.5552 29.203 -12.5869 +7020 6 54.3296 23.3325 28.9716 1.50467 4.34178 0.834044 +7021 4 54.2574 22.8567 29.7964 -0.193368 0.82753 11.1745 +7022 4 54.4723 22.6371 28.331 0.325397 -5.40149 -8.07104 +7023 6 14.3127 12.1509 35.6633 -33.5663 -10.8168 -13.6472 +7024 4 14.2878 12.7047 36.4184 6.74358 21.3133 20.6565 +7025 4 15.1756 11.8015 35.6107 35.8459 -8.25269 -4.05635 +7026 6 18.9986 6.53226 41.2771 -21.1361 -24.8418 -24.3627 +7027 4 18.366 5.78703 41.1105 9.63211 18.6573 18.8829 +7028 4 19.3119 6.48514 0.272589 3.11598 2.01554 11.5533 +7029 6 5.32991 17.8836 20.3428 -30.4167 16.0599 6.69424 +7030 4 4.7967 18.411 19.709 2.93149 -9.05217 4.33299 +7031 4 4.77097 17.8526 21.1546 15.0176 4.61027 -13.5236 +7032 6 24.7236 34.9657 30.1688 -3.59195 -26.0802 -14.261 +7033 4 24.7803 35.9013 30.0428 5.00342 21.1487 3.94382 +7034 4 24.6904 34.5809 29.2706 1.13339 13.2018 12.9935 +7035 6 31.868 4.6188 18.1813 26.0749 -11.7783 -2.21043 +7036 4 31.7807 5.26575 18.8694 -2.85928 14.415 8.06415 +7037 4 31.0011 4.54965 17.8036 -17.7428 -0.954819 -5.29079 +7038 6 8.70915 17.4782 5.92977 -5.10088 36.478 0.166614 +7039 4 7.99285 18.1665 5.8727 10.0003 -20.7449 -0.10219 +7040 4 9.53277 18.014 5.87919 -8.17468 -12.6369 7.06335 +7041 6 29.8448 10.9674 14.467 -9.24737 10.8237 6.24964 +7042 4 29.3518 11.4625 13.8111 -3.5417 -3.22768 -11.9456 +7043 4 29.8741 11.602 15.1948 7.6561 -6.41884 12.5924 +7044 6 48.7193 10.2987 32.5837 48.7914 -16.5053 -5.27468 +7045 4 48.664 9.84191 33.449 -1.5926 15.0761 -9.20872 +7046 4 49.6917 10.1556 32.2801 -49.2626 10.4163 8.33251 +7047 6 8.33128 15.6672 37.865 4.36755 4.12409 -33.9682 +7048 4 8.08142 16.0688 38.661 -6.22033 14.9054 48.1983 +7049 4 7.78443 16.1766 37.2488 7.82296 -4.92397 -7.06368 +7050 6 50.3849 3.07587 17.3306 53.0616 0.797084 -5.54454 +7051 4 49.9901 2.96071 16.4818 -23.7547 4.5323 -14.3202 +7052 4 49.831 3.21284 18.0832 -29.2444 4.71684 15.357 +7053 6 14.687 38.3962 10.9034 11.8452 2.26847 -28.7684 +7054 4 14.4993 38.5723 11.8231 -13.1425 0.700252 11.382 +7055 4 14.2628 37.5785 10.602 -2.45756 1.24341 13.1034 +7056 6 34.1174 6.37976 10.8168 12.9161 5.50138 13.5595 +7057 4 34.1292 7.23477 10.3416 2.23773 -14.4836 1.59416 +7058 4 34.9287 6.34152 11.3848 -14.7297 9.70771 -12.8953 +7059 6 7.1619 37.5492 17.6341 50.2032 -5.81562 0.15107 +7060 4 8.17599 37.5098 17.465 -47.7372 -0.307972 7.49553 +7061 4 7.05745 37.0565 18.4805 -8.53445 9.44148 -12.9936 +7062 6 51.515 11.3168 16.7982 -26.0757 5.86397 -27.0874 +7063 4 52.235 10.8459 17.1551 30.0977 -19.3818 20.7126 +7064 4 51.5008 11.0547 15.8562 -2.22905 10.0255 8.80825 +7065 6 15.6633 8.64974 3.19872 2.04011 -21.0584 -36.8111 +7066 4 15.359 9.2987 3.81038 -7.3063 19.0886 25.5551 +7067 4 16.1924 8.00887 3.67257 5.32849 -2.14206 7.59436 +7068 6 5.43671 21.4488 11.9213 -35.1135 30.2715 2.68526 +7069 4 5.1197 22.3031 11.5306 26.1226 -15.3225 -1.30607 +7070 4 4.71321 21.2794 12.5494 12.8867 -7.97314 3.40019 +7071 6 50.1888 24.041 37.9733 -16.5158 11.6838 -8.72192 +7072 4 49.5513 24.2503 37.2525 13.6843 -9.6942 16.9361 +7073 4 50.7608 23.3204 37.7156 0.52347 -2.66969 -5.08066 +7074 6 39.7366 11.2383 31.6978 23.7892 31.0409 -10.9794 +7075 4 40.3477 11.919 31.322 -8.85632 -23.7146 9.45819 +7076 4 38.8907 11.643 31.516 -11.7678 -2.00245 1.00495 +7077 6 26.6862 10.831 20.5846 -4.64528 13.8134 22.6501 +7078 4 26.37 11.3609 21.3584 5.46785 -6.26709 -23.7021 +7079 4 26.5097 9.94471 20.9062 3.28762 -9.42115 -6.7075 +7080 6 12.5617 17.5693 18.1619 57.3415 -16.6047 -35.4946 +7081 4 12.3732 16.6356 17.927 -10.1847 12.7431 11.2408 +7082 4 11.9536 17.9401 18.7496 -47.3477 6.23269 31.2745 +7083 6 47.7779 31.603 17.3345 -16.0229 -2.6295 -18.0517 +7084 4 48.4774 31.3981 17.9449 0.342859 -12.7175 10.4199 +7085 4 47.3751 30.7658 17.0144 6.51745 15.1025 2.87388 +7086 6 1.06661 3.38166 18.5387 0.482315 1.39351 -20.5486 +7087 4 1.47214 3.81044 19.3024 -7.19452 2.23946 8.83247 +7088 4 0.121217 3.21323 18.6865 2.92702 6.89788 10.7589 +7089 6 26.5916 20.3882 15.3141 4.05487 -19.1164 -7.10575 +7090 4 27.0276 19.5492 15.0037 -7.93965 16.9744 10.3813 +7091 4 25.6772 20.1067 15.4922 9.40368 -0.641397 -3.80974 +7092 6 42.0092 3.03717 36.7607 9.58516 7.42569 -27.539 +7093 4 41.472 2.27114 36.5289 -4.68032 -10.5632 12.6255 +7094 4 41.9749 3.27199 37.6769 -10.2045 -8.66607 25.0137 +7095 6 39.3197 22.4482 33.2161 17.1359 -6.1719 -1.11969 +7096 4 39.6777 22.5385 34.1471 -14.6651 4.73191 -34.7467 +7097 4 39.2891 23.3308 32.7977 1.66572 -7.01471 12.3298 +7098 6 18.4983 34.959 11.9233 -52.4092 11.8234 -6.15541 +7099 4 19.3311 34.9297 12.2931 62.358 -5.27325 28.8625 +7100 4 17.9525 35.2018 12.6795 -15.7268 -2.39727 1.11957 +7101 6 22.849 14.1156 0.206953 9.43339 -22.8796 20.8561 +7102 4 23.1273 14.7687 41.4941 9.338 18.1693 -9.76493 +7103 4 23.4344 14.2183 0.991573 -8.36464 7.13735 -11.7533 +7104 6 31.0127 16.6435 33.7717 -75.3989 -12.3916 10.6429 +7105 4 30.4261 16.8588 33.0132 20.7291 0.745933 12.1228 +7106 4 31.8948 16.7604 33.5238 39.9201 13.7608 -15.1754 +7107 6 28.4056 35.5121 5.54765 -4.91817 12.0412 -0.933493 +7108 4 29.0647 34.8486 5.74161 15.0982 -5.96625 -1.02933 +7109 4 28.8561 36.3656 5.44297 -1.6946 -6.58589 1.12865 +7110 6 2.06022 31.4415 10.6404 20.6415 1.38777 10.2498 +7111 4 2.4899 32.1989 10.2195 -2.44284 -2.19106 -3.22737 +7112 4 1.13111 31.6267 10.6164 -17.6565 -0.143118 -7.1498 +7113 6 5.95467 9.75858 21.3545 2.17354 8.87983 -50.8842 +7114 4 6.2643 10.5435 20.7894 -11.3634 -34.5597 22.4005 +7115 4 5.48441 9.14719 20.7121 9.8282 23.6666 23.1144 +7116 6 24.7866 26.6177 2.6661 -24.4024 -28.5469 2.9707 +7117 4 23.9476 26.6963 2.18158 9.10826 11.4817 -7.6186 +7118 4 24.6214 25.7954 3.1805 15.5163 19.2379 2.11057 +7119 6 45.7515 4.24664 18.6084 -0.948574 6.19926 2.59566 +7120 4 46.4738 4.91595 18.5123 -9.05862 -19.7882 -0.326833 +7121 4 46.0843 3.34349 18.421 4.31178 15.089 3.21664 +7122 6 4.45878 0.783326 15.9106 20.8465 2.39674 -2.22601 +7123 4 4.33336 41.7534 15.8294 -11.1347 -14.3847 -2.31303 +7124 4 5.37758 0.813141 16.2285 -10.0444 13.1447 -0.149196 +7125 6 2.44065 19.4988 25.3899 -18.2163 -19.9205 28.2208 +7126 4 1.89428 18.9873 26.0273 4.60516 17.0002 -8.33323 +7127 4 2.55045 18.8717 24.6878 9.48029 -1.77855 -17.0048 +7128 6 40.6027 8.48954 5.10826 -27.6355 -21.4881 -13.6167 +7129 4 40.6592 9.31425 5.57088 10.9479 16.5697 14.8472 +7130 4 41.3781 7.96424 5.30637 14.4251 2.68711 -2.52113 +7131 6 49.3092 22.3481 41.5186 -9.93734 74.0457 16.0776 +7132 4 48.4971 22.7919 41.1786 21.3857 -10.289 -0.267672 +7133 4 49.2285 21.4633 41.2985 -4.59952 -62.95 -16.8011 +7134 6 0.364483 40.9333 20.5966 -24.8933 -11.8265 -30.66 +7135 4 0.190818 39.9667 20.5681 4.35782 8.08342 1.06674 +7136 4 54.6936 41.3396 19.9676 13.1862 -7.22974 19.6204 +7137 6 34.8864 15.3279 38.0452 -17.1782 37.3505 -55.2903 +7138 4 34.2682 16.0872 37.9321 5.94042 -16.3876 6.60377 +7139 4 35.3697 15.4116 37.1797 -1.56134 -6.74346 24.1748 +7140 6 7.76223 25.9987 29.8652 25.7268 -8.51605 -4.95409 +7141 4 8.61839 26.4638 29.9588 -13.1921 -1.71741 1.7916 +7142 4 8.05672 25.0651 29.9772 -19.4202 16.3818 3.54783 +7143 6 40.7182 22.7954 20.4441 37.8127 13.8011 -33.8007 +7144 4 41.3586 23.4588 20.0133 -28.9149 -26.2189 23.8294 +7145 4 40.2017 23.2969 21.0583 -10.7099 15.3396 13.8501 +7146 6 37.6932 25.6399 36.0638 4.62997 10.0285 35.1853 +7147 4 38.3287 24.9236 36.1183 -2.20273 -4.01008 -9.65359 +7148 4 37.2914 25.6394 35.2107 -7.09628 -5.12362 -31.4654 +7149 6 5.46101 24.0014 10.2586 17.9799 16.5872 6.22131 +7150 4 6.04134 23.844 9.49543 -11.5162 -2.35388 5.85767 +7151 4 5.90746 24.7967 10.672 -23.415 -30.7572 -16.8601 +7152 6 48.4104 21.0451 38.1819 10.5351 27.9197 -28.7006 +7153 4 48.793 20.7803 39.017 13.2175 -6.38321 0.209366 +7154 4 49.1228 21.3802 37.5459 -28.8109 -18.4864 30.6779 +7155 6 15.2906 25.011 3.54101 2.70625 6.69817 -9.95824 +7156 4 15.4569 24.0555 3.50682 -9.52162 -0.514188 6.9158 +7157 4 14.6826 25.2483 4.2581 -1.83637 -10.9582 1.3864 +7158 6 46.3949 40.2718 20.0841 3.05266 -42.5213 0.389481 +7159 4 46.7282 39.319 20.1688 -17.5494 37.8624 -2.40649 +7160 4 47.138 40.8016 20.3323 14.2597 18.5668 -0.122304 +7161 6 34.6662 36.4732 0.324161 -52.0076 35.1593 -1.38074 +7162 4 34.82 35.9689 1.09464 17.4812 -18.6855 30.1307 +7163 4 33.7817 36.8781 0.601954 33.7085 -7.09846 -24.72 +7164 6 52.5968 8.00424 30.4116 -30.791 -5.83914 -1.44892 +7165 4 52.0396 8.66036 30.8559 12.8564 7.40177 -0.477247 +7166 4 51.9287 7.58179 29.8369 22.2614 -6.63703 0.63559 +7167 6 32.0772 3.86049 29.4688 -16.0025 -7.01815 -35.05 +7168 4 31.5382 3.03776 29.5615 20.8838 14.671 -1.22835 +7169 4 32.0904 4.03293 28.4798 -1.86833 -11.5506 40.3284 +7170 6 20.363 17.8245 28.646 3.47804 13.7512 -7.92665 +7171 4 19.5516 17.4966 29.0653 6.53113 9.74715 -6.36853 +7172 4 20.0825 18.3002 27.8308 0.555567 -8.90179 15.8758 +7173 6 30.4041 41.1634 41.0132 -16.7253 12.0993 -9.83452 +7174 4 30.5197 40.835 40.1072 4.71307 -5.7925 7.34595 +7175 4 31.1703 40.9637 41.5368 18.7313 -7.07732 1.06037 +7176 6 35.4542 32.8539 27.9215 21.6406 26.5455 -21.3275 +7177 4 35.1435 33.2362 28.7432 -6.21594 5.85967 7.97646 +7178 4 35.8745 33.6007 27.3754 -13.2283 -32.0923 16.9769 +7179 6 14.39 6.67952 12.731 -12.5058 36.491 0.424373 +7180 4 15.2321 6.28981 12.9462 8.74388 -6.1299 -2.75421 +7181 4 14.5067 7.66796 12.7988 -3.69921 -34.1177 -6.56265 +7182 6 41.8739 41.5433 20.319 24.4238 12.2951 6.29746 +7183 4 42.7192 41.2715 19.9184 -11.0628 6.38436 -6.30872 +7184 4 41.3184 40.7767 20.2955 -10.4459 -12.1473 -5.48062 +7185 6 46.3985 22.5739 8.8638 6.84921 19.3184 1.79378 +7186 4 45.8729 21.8991 8.42669 -3.07803 -12.5032 3.12866 +7187 4 47.1271 22.1566 9.33065 -8.50589 -8.34396 1.5145 +7188 6 17.4023 20.6526 13.9004 10.6995 28.5611 -11.4854 +7189 4 17.6978 21.6036 13.9579 -8.84666 -31.3302 7.07381 +7190 4 17.3123 20.5004 12.9448 0.490636 -3.23538 4.08121 +7191 6 8.20126 9.48382 13.3485 -42.4293 41.8522 17.2798 +7192 4 7.44487 10.0964 13.6076 19.5538 -29.8853 -13.4391 +7193 4 8.9576 10.0119 13.6277 13.7224 -9.45646 -1.54211 +7194 6 7.58554 14.8008 29.5824 -2.61798 9.90858 -2.64866 +7195 4 7.05733 14.3538 30.2458 -0.514214 1.68252 7.63674 +7196 4 7.01989 15.5029 29.2149 4.91731 -6.06465 -0.976267 +7197 6 29.5668 39.2268 22.6285 -3.66094 -2.39634 13.3419 +7198 4 29.8353 38.7557 23.4169 -4.20308 -7.76017 12.2752 +7199 4 30.3745 39.2765 22.1369 12.5997 4.36069 -18.8462 +7200 6 19.725 28.7952 8.44488 15.8543 2.58223 -4.45186 +7201 4 19.5131 27.8757 8.63421 -2.81313 1.38303 -4.16069 +7202 4 20.6983 28.808 8.54393 -13.7447 6.84799 3.59225 +7203 6 20.0995 21.6275 25.9249 -17.5249 50.4223 5.09745 +7204 4 20.7082 22.0204 26.5908 -8.84326 -18.264 -10.6066 +7205 4 19.3931 22.3347 25.9239 13.215 -30.9895 -3.48111 +7206 6 12.7711 16.1006 22.7986 17.0661 -2.75106 -3.7002 +7207 4 12.1316 16.7784 22.5952 -11.3059 6.43976 -4.8982 +7208 4 12.4647 15.3033 22.3372 -2.13756 9.04884 6.71194 +7209 6 7.09175 27.2069 17.991 -23.617 26.2366 -1.29155 +7210 4 7.8076 26.6007 17.9383 20.2011 -26.8554 -5.74897 +7211 4 7.19403 27.792 17.2318 3.33647 -0.0238245 -0.788587 +7212 6 32.3975 8.68618 34.8629 3.54321 22.8272 16.3539 +7213 4 32.7738 9.06402 35.707 -18.9002 -9.48773 -27.5474 +7214 4 31.4989 9.0701 34.6771 23.7457 -9.58556 9.46102 +7215 6 50.3515 28.2186 17.5351 -6.87553 0.519429 12.9107 +7216 4 50.2481 27.3572 17.999 6.5408 9.8464 -12.2276 +7217 4 51.0722 28.1417 16.8919 -2.26653 -7.3618 -1.59066 +7218 6 15.6741 32.1546 25.7968 -26.4348 -11.0143 -14.9159 +7219 4 16.4004 32.6083 26.1805 24.7846 13.6092 10.6573 +7220 4 15.1411 32.8481 25.3674 4.92309 -4.07512 11.5217 +7221 6 41.2877 22.001 29.6411 43.1174 -21.5596 15.2505 +7222 4 40.6305 22.5901 29.3541 -33.8214 23.827 -16.0773 +7223 4 40.8662 21.2212 29.998 -7.36398 -2.60921 4.02408 +7224 6 24.5416 12.7608 8.88206 5.17198 -11.9982 -20.3907 +7225 4 24.1774 13.5122 9.35398 1.69504 4.6425 -2.53241 +7226 4 24.2888 12.8675 7.94212 1.28664 -3.68024 15.0016 +7227 6 47.3025 20.1085 10.3977 1.21439 24.4816 37.2747 +7228 4 48.204 20.4596 10.4656 -0.7364 -8.12719 -10.3932 +7229 4 47.15 19.5905 9.61989 6.68365 -16.152 -23.0167 +7230 6 17.6916 14.2112 29.9613 0.736848 4.98565 -22.9932 +7231 4 16.8377 14.622 30.0672 -16.7241 9.37988 10.4211 +7232 4 18.1183 14.7557 29.2835 1.70081 -6.05446 6.16757 +7233 6 21.3481 34.5805 28.5342 -9.54463 9.82799 -20.865 +7234 4 21.5933 35.4178 28.0943 -1.05427 -4.62886 14.5387 +7235 4 21.7361 34.566 29.3968 13.4346 0.0141216 16.9261 +7236 6 35.1024 4.03924 4.01172 -45.5158 42.5484 12.3245 +7237 4 34.1858 3.89939 4.38295 32.1954 -12.7538 -7.33111 +7238 4 35.1016 5.02916 3.89259 9.91862 -26.8751 2.91657 +7239 6 29.9059 8.58368 22.6013 -13.5917 -22.6535 -48.6732 +7240 4 29.4773 8.30259 21.7189 15.3855 19.7125 42.6195 +7241 4 30.4378 7.8025 22.8052 -0.87874 9.41284 8.39762 +7242 6 9.78314 32.9658 15.9197 34.9354 -36.2496 39.6827 +7243 4 9.8463 32.0623 16.3137 -14.5131 14.3099 -26.4053 +7244 4 10.4229 33.3707 16.5321 -2.5459 17.7355 -14.0184 +7245 6 24.9212 14.2335 32.582 19.5351 -17.8621 25.1352 +7246 4 25.485 14.4356 33.3711 -14.9506 -0.509299 -20.0473 +7247 4 24.5508 15.0526 32.2925 -5.32053 16.7872 -6.18619 +7248 6 49.6539 21.965 26.2345 44.0267 25.2751 -8.97422 +7249 4 50.4399 21.435 26.5572 -22.3889 20.3635 -4.11669 +7250 4 50.0214 22.8598 25.9362 -18.5294 -37.2714 15.3372 +7251 6 39.2165 29.6282 28.7804 -1.72389 1.82743 -9.11301 +7252 4 39.3036 29.0201 29.5259 1.24025 -1.09654 1.55877 +7253 4 39.538 29.1266 28.0158 0.286751 -1.49672 5.82908 +7254 6 50.6899 34.7862 39.7499 25.3157 10.1005 12.0928 +7255 4 51.6472 34.6743 39.5192 -19.7186 -4.86584 -0.193213 +7256 4 50.1651 34.2508 39.1591 2.72681 -14.2758 -14.8682 +7257 6 29.2004 20.8742 19.5261 27.9811 -3.68804 20.7377 +7258 4 30.1466 21.1247 19.5553 -9.39276 -2.96688 2.79863 +7259 4 28.9246 21.1497 18.6738 -22.5466 15.5983 -24.0329 +7260 6 45.8438 1.42491 21.3861 -37.1737 6.40486 -10.0566 +7261 4 44.9885 1.11968 21.7285 6.97513 -0.0444158 -7.72874 +7262 4 46.4438 0.92117 21.8904 34.782 -15.8409 16.3481 +7263 6 26.1011 5.84859 12.9885 -16.9285 4.46913 -7.38549 +7264 4 26.5547 5.08441 12.6375 7.71787 -14.9735 6.0022 +7265 4 25.1614 5.66972 12.8036 4.71997 0.43883 -1.19571 +7266 6 9.00669 19.0403 23.7238 12.8928 30.373 -14.6892 +7267 4 8.06593 18.9071 23.7945 -12.9763 -5.98489 5.20443 +7268 4 9.0473 19.9093 23.2431 5.0983 -22.172 6.64837 +7269 6 47.6961 14.1782 40.0269 19.0377 9.97795 -11.4729 +7270 4 48.5222 14.3512 39.5239 -16.7083 -4.37767 10.6105 +7271 4 47.3795 15.0553 40.2888 -5.04524 -6.44815 -3.81417 +7272 6 47.9985 19.7874 0.500962 -66.9165 -27.0064 -39.4066 +7273 4 48.5513 19.9496 1.22397 26.1904 -2.55385 45.3318 +7274 4 47.2789 19.103 0.704655 34.6798 29.0788 0.973802 +7275 6 27.1606 39.6013 31.4318 -10.4761 -55.491 -38.6851 +7276 4 26.8926 40.2811 32.0159 -13.7359 20.3686 20.1783 +7277 4 26.3709 38.9998 31.2101 25.3937 25.349 18.055 +7278 6 20.7209 15.2822 27.3078 -0.805435 -7.71632 -8.78017 +7279 4 19.7876 15.3781 27.0487 8.25469 13.9731 2.34115 +7280 4 21.2532 16.0335 26.9925 -16.2498 2.55153 -4.46604 +7281 6 53.2722 3.12643 19.6849 41.3384 49.6686 7.26214 +7282 4 52.533 3.74254 19.7043 -8.02663 -2.92583 -3.0848 +7283 4 53.0086 2.23956 19.6703 -22.4403 -46.3419 -2.11618 +7284 6 40.7531 33.3786 24.0219 13.5521 -1.60379 23.9632 +7285 4 41.5067 33.1664 24.6167 -8.75803 3.71621 -14.936 +7286 4 40.1104 32.6626 24.1628 3.50492 2.6284 -2.95087 +7287 6 50.2066 37.8896 21.3771 44.4561 61.7722 -19.2089 +7288 4 50.9779 37.3435 21.496 14.3962 -14.5259 7.12428 +7289 4 49.4598 37.4098 21.5582 -59.0635 -51.549 13.7135 +7290 6 41.3233 2.3412 21.9924 -16.3503 12.7858 19.6024 +7291 4 41.3426 2.52207 21.0679 5.97541 2.4567 -21.4637 +7292 4 40.4663 2.75609 22.2585 17.532 -18.0725 0.252127 +7293 6 3.68867 21.2779 14.3383 -14.5707 42.5 -35.9941 +7294 4 4.12477 21.855 14.9587 9.56216 12.6885 8.47194 +7295 4 3.77328 20.4352 14.6935 9.76412 -50.205 23.6517 +7296 6 34.2782 11.1533 36.6146 -6.03132 -23.9347 13.7336 +7297 4 33.9924 10.5436 37.3334 13.9996 -4.78487 -21.5854 +7298 4 34.1172 11.978 37.0322 -7.62349 27.2634 9.28858 +7299 6 24.0533 21.9225 23.4615 4.73517 -5.47775 13.1649 +7300 4 23.9978 21.53 22.5886 6.00444 -6.53009 -8.74438 +7301 4 24.605 21.2935 23.9896 -10.4931 14.2472 -9.63662 +7302 6 18.8931 0.346665 4.41951 -1.70081 19.9518 7.76538 +7303 4 18.8368 41.3461 4.13842 4.04101 -8.25805 2.22226 +7304 4 19.3845 0.416823 5.25819 -4.2619 -8.11151 -12.0763 +7305 6 1.61167 7.82777 17.7295 14.4633 -7.55708 2.21629 +7306 4 1.68315 6.88308 17.5181 0.421421 7.02752 -3.81945 +7307 4 0.776664 7.94842 18.1735 -9.56642 1.01884 2.20602 +7308 6 9.88587 31.542 26.4865 27.4574 -58.0414 -32.6279 +7309 4 9.74723 30.8294 25.7579 9.18818 32.443 34.13 +7310 4 9.16596 32.1271 26.4328 -35.6644 31.0992 -1.66616 +7311 6 46.989 33.006 20.3636 -11.9681 -37.8677 44.1235 +7312 4 47.0707 32.5253 21.2626 7.56487 31.1056 -35.1941 +7313 4 46.435 32.3629 19.8924 4.61548 9.19147 -10.8851 +7314 6 49.5457 29.2916 21.3977 -38.7846 4.15079 -24.0209 +7315 4 50.3477 28.8236 21.2219 24.323 -7.55681 13.7085 +7316 4 49.5468 29.8542 22.1736 14.9668 -0.936193 10.2574 +7317 6 13.5153 31.8979 19.1528 13.8675 8.3184 29.6787 +7318 4 12.8458 31.9825 19.8587 16.0999 2.21739 -7.32054 +7319 4 14.3406 32.2634 19.5906 -25.0701 -6.26478 -24.6616 +7320 6 46.633 34.1066 16.9257 -0.036059 -36.1463 20.7227 +7321 4 46.8492 33.9929 15.9997 3.99258 8.43366 -10.882 +7322 4 46.9059 33.2223 17.3084 -4.9703 29.3867 -9.59361 +7323 6 19.7609 39.5392 2.42166 -7.20248 -0.896063 -14.0911 +7324 4 20.5606 40.0527 2.5788 -3.5749 4.99115 -1.28658 +7325 4 19.2738 40.0463 1.72337 11.6568 -15.7424 21.4794 +7326 6 16.5329 9.39795 28.3065 -12.6095 -8.72502 6.68605 +7327 4 16.4075 10.3536 28.3648 10.1088 3.80195 -3.74389 +7328 4 17.4502 9.20269 28.1082 11.2813 2.72217 -1.81406 +7329 6 3.0433 33.3643 8.96425 -4.92886 23.6682 -21.9772 +7330 4 2.41869 34.0757 8.74286 -2.57616 0.180013 17.6579 +7331 4 3.16376 33.0029 8.08154 7.55925 -16.3918 2.91827 +7332 6 49.6751 28.308 0.201579 -29.5359 7.30765 2.58258 +7333 4 50.5733 28.3754 41.8671 34.4717 0.327786 -9.88202 +7334 4 49.5726 27.4715 0.657175 -2.26504 -2.01296 8.34302 +7335 6 1.41619 6.84354 30.4994 -10.3235 0.0954103 3.42179 +7336 4 1.63397 7.74222 30.8225 4.19995 -13.4757 3.05915 +7337 4 0.761793 6.45905 31.124 14.5617 20.0187 -8.0296 +7338 6 19.7679 9.42131 33.717 -3.22882 -6.25654 -44.8315 +7339 4 19.9145 8.46604 33.7746 1.8774 1.59257 2.48781 +7340 4 19.5751 9.55831 32.7323 1.24521 6.76178 40.819 +7341 6 26.1724 11.919 3.61074 17.7641 10.7445 -19.8393 +7342 4 25.5356 12.1934 4.24073 -14.9718 14.8208 22.8097 +7343 4 26.0423 10.983 3.54915 1.55706 -20.7566 2.99847 +7344 6 33.2542 2.1444 18.2116 -1.15587 48.9982 3.93816 +7345 4 32.886 2.96086 18.6548 6.67205 -21.4839 -22.8104 +7346 4 32.6761 1.46025 18.493 -13.9253 -19.4899 6.26155 +7347 6 1.55797 29.1194 15.6221 -22.3111 36.2637 61.7506 +7348 4 0.853719 28.5449 15.936 -7.71843 6.28063 0.384394 +7349 4 1.90648 28.6788 14.9107 30.7784 -39.3832 -62.5327 +7350 6 41.7311 4.10421 39.5944 -40.7328 36.7616 -42.7174 +7351 4 41.3817 4.81242 38.923 27.6667 -38.3892 36.6931 +7352 4 40.9025 3.64602 39.8145 11.2401 -8.56921 5.26404 +7353 6 28.6823 41.7982 21.1955 47.2047 1.42594 -8.59686 +7354 4 29.177 0.720645 21.3267 -21.6507 -0.473723 0.486784 +7355 4 29.4617 41.2314 21.0003 -26.4876 -3.65191 3.02858 +7356 6 11.643 12.3982 35.4482 -35.2927 22.3423 -20.2863 +7357 4 11.5968 12.2307 36.3713 6.75035 -5.55932 30.2124 +7358 4 12.5522 12.401 35.2267 32.0712 -2.0845 -6.40416 +7359 6 9.80556 12.056 0.297197 42.0735 31.0338 -28.3715 +7360 4 10.6577 12.4693 0.65483 -33.0881 -22.384 -10.4034 +7361 4 9.20254 11.76 0.941289 -12.1624 -10.8407 36.4861 +7362 6 48.1632 12.393 9.2137 2.43833 7.21341 -5.5951 +7363 4 48.4522 11.811 8.50685 -9.57081 -7.25037 -8.94466 +7364 4 48.8896 12.3474 9.83523 7.41749 2.43397 12.8852 +7365 6 20.1331 24.378 18.9556 11.9182 2.36756 -38.9603 +7366 4 19.4372 23.8368 18.5171 17.2732 8.77886 9.60074 +7367 4 20.7988 24.6336 18.2364 -23.7637 -10.2166 26.3276 +7368 6 16.5494 31.2838 16.4573 -15.9423 3.69088 33.2062 +7369 4 16.5519 32.1922 16.7594 11.1434 16.9832 -11.781 +7370 4 16.1476 30.8867 17.2522 1.55385 -15.8871 -15.2552 +7371 6 1.78983 14.6435 36.2904 4.99553 5.58283 2.2492 +7372 4 1.04893 14.2282 35.8708 -13.8588 -3.35469 -16.6141 +7373 4 1.66905 14.392 37.2023 2.39459 2.07051 19.2387 +7374 6 4.37166 29.2153 29.5914 5.79168 20.1405 -19.3585 +7375 4 4.91557 28.7254 30.2154 7.17051 0.117226 5.39869 +7376 4 4.91513 29.9512 29.1891 -14.7291 -26.607 12.32 +7377 6 43.6969 0.237019 22.6594 -7.19613 -4.49497 -5.57098 +7378 4 43.0237 0.783547 22.2316 -12.2242 -6.81623 2.03469 +7379 4 43.4415 41.2053 22.5454 5.15142 14.113 -1.35906 +7380 6 52.5052 40.9917 27.2414 -4.0762 -16.2903 -30.037 +7381 4 52.8129 40.7577 26.3208 -10.5132 10.5144 20.9332 +7382 4 53.295 41.2999 27.6882 6.37269 9.42971 1.77711 +7383 6 25.5785 23.9088 27.7352 -29.163 -0.147769 2.09076 +7384 4 24.7169 24.3904 27.6009 26.0068 -16.0483 4.45096 +7385 4 26.303 24.4711 27.4736 4.98376 5.99744 -3.44082 +7386 6 23.1322 17.0409 33.3147 -4.87562 4.34963 6.5261 +7387 4 23.1435 17.5188 34.1474 -0.665908 -2.26574 -1.07751 +7388 4 22.9237 16.1327 33.5379 -5.85649 -9.89669 4.05086 +7389 6 2.9235 11.8719 21.3628 -62.5775 -31.8178 -28.2901 +7390 4 2.1985 11.2347 21.6738 31.4392 30.9604 -16.9464 +7391 4 3.51176 11.9111 22.066 35.7266 4.49799 37.8533 +7392 6 2.17958 4.14491 30.0321 9.06251 -9.53771 -13.2585 +7393 4 2.15165 5.09682 30.107 -1.56529 16.7016 0.150815 +7394 4 2.7299 3.97467 29.2422 -7.5281 0.377543 4.10315 +7395 6 26.6694 30.2855 13.4776 10.1196 11.7228 27.7054 +7396 4 25.7357 30.4785 13.6549 -0.51692 -11.2356 -3.98914 +7397 4 27.0778 30.3597 14.373 -6.55394 -4.70072 -25.9179 +7398 6 24.8731 30.8123 10.8246 -35.9544 -8.06722 -7.65859 +7399 4 25.2097 30.0125 10.4324 5.41746 -9.73411 -7.41209 +7400 4 25.6149 31.228 11.1936 31.2673 18.7081 18.3938 +7401 6 53.1638 24.1184 4.51161 -10.4445 -35.9395 21.0824 +7402 4 53.5233 24.7957 3.98549 14.2054 30.1141 -21.0763 +7403 4 53.9237 23.6117 4.81383 2.71167 2.31883 7.09562 +7404 6 24.8958 4.51213 23.9931 -29.6363 -43.6073 15.3227 +7405 4 24.1339 5.1036 23.9039 18.5944 16.8193 -2.99678 +7406 4 25.7258 4.88904 23.7461 22.8138 27.5954 -9.18982 +7407 6 34.6838 1.65591 41.2514 12.8053 -23.083 -29.6978 +7408 4 35.6244 1.45761 41.0729 -14.4971 0.421146 -0.177754 +7409 4 34.7301 1.99199 0.211928 -2.47028 17.9107 34.9925 +7410 6 13.312 19.5249 16.387 18.9594 -19.3284 17.3248 +7411 4 13.9333 19.1674 15.7225 -9.24732 -4.9188 0.52103 +7412 4 13.2597 18.8166 17.0929 -3.23838 18.5958 -24.3952 +7413 6 48.698 0.181353 20.409 -0.21633 -26.9433 -24.4133 +7414 4 49.103 41.5184 19.698 -4.34753 24.5911 30.5043 +7415 4 48.7986 41.623 21.2469 8.80211 1.41451 -0.511645 +7416 6 43.0644 27.7916 11.5133 -14.5871 -6.12813 -9.0892 +7417 4 42.6 28.0105 10.6776 10.2055 -1.97818 11.3293 +7418 4 43.4908 28.591 11.8257 3.55806 4.66568 -1.20709 +7419 6 25.6909 21.365 35.1834 16.6334 21.4278 -26.2382 +7420 4 25.8486 22.0441 34.4664 -6.54449 -15.4554 28.1071 +7421 4 25.5413 20.5536 34.6727 -4.24699 7.33591 15.2905 +7422 6 44.7232 4.60607 27.7619 9.66663 0.618053 -4.25407 +7423 4 44.3234 4.00717 27.1079 -6.11804 2.34462 0.765623 +7424 4 44.3971 5.50639 27.5932 -3.06611 -6.30885 -0.545657 +7425 6 41.2897 11.4432 34.2066 -9.61739 21.0206 -8.56292 +7426 4 40.6842 11.5664 33.4581 3.14959 1.41378 -1.0752 +7427 4 41.1924 10.5195 34.3892 0.589219 -23.8889 7.33677 +7428 6 19.897 36.6492 2.04794 -32.5825 5.5481 -21.6378 +7429 4 20.6399 36.2361 2.4987 10.0826 10.558 0.716761 +7430 4 19.9026 37.6342 1.97212 14.9366 -15.8518 15.2433 +7431 6 27.4836 4.66736 6.35028 2.97665 -65.4375 -50.0742 +7432 4 27.6123 3.82169 6.79207 -3.46759 -4.72632 -9.32934 +7433 4 27.4741 5.24116 7.04108 -4.39889 64.7262 58.0755 +7434 6 16.8382 30.7844 39.9326 10.6925 -56.0648 15.7324 +7435 4 17.0186 31.2572 40.7403 -2.33579 15.7179 12.0581 +7436 4 17.0831 29.8382 40.1617 -5.04661 27.4351 -11.6424 +7437 6 51.1641 15.1933 16.3324 21.7581 16.0625 -9.079 +7438 4 51.121 16.0888 15.8936 10.5188 -25.5533 9.6052 +7439 4 52.0677 14.7794 16.1385 -37.3149 17.1399 3.28502 +7440 6 49.9904 21.2241 35.9744 20.9503 -33.7397 19.542 +7441 4 49.3714 21.5088 35.3291 -23.4605 10.1211 -23.8745 +7442 4 49.9121 20.2362 36.0002 2.40052 26.2853 0.00810801 +7443 6 34.428 0.14016 5.66944 -7.82493 37.3161 8.31948 +7444 4 34.304 0.843366 6.34479 2.68801 -11.9822 -16.4886 +7445 4 34.2591 0.582485 4.80419 9.04141 -16.6905 11.7821 +7446 6 48.3182 11.536 19.8764 -48.9228 13.3726 26.2823 +7447 4 47.7285 11.3649 20.663 34.2262 -2.74449 -19.9886 +7448 4 47.7235 12.1441 19.3775 23.4884 -14.873 -2.11476 +7449 6 4.19152 39.4305 13.3555 27.463 28.0369 44.5079 +7450 4 4.88401 39.7456 14.019 -21.6239 -15.7277 -33.754 +7451 4 3.37287 39.6897 13.8148 -3.76347 -10.7833 -11.4512 +7452 6 8.74995 16.191 8.53596 -5.05856 2.64204 -21.058 +7453 4 8.7323 16.8633 9.22906 0.669847 -0.203387 -6.91741 +7454 4 8.69158 16.6347 7.64451 3.76071 -7.46014 24.9197 +7455 6 29.0285 14.2822 26.5262 -5.84817 34.0816 17.5192 +7456 4 29.0044 15.2824 26.745 3.30971 -49.1818 -9.92417 +7457 4 28.1563 13.9159 26.7584 2.39554 12.59 0.416474 +7458 6 27.3852 14.5292 8.14264 -25.3608 8.37865 0.80053 +7459 4 26.4121 14.3996 8.08331 21.4517 0.6706 1.76752 +7460 4 27.495 15.4908 8.29449 3.73212 -17.2528 -1.50339 +7461 6 14.1265 27.2071 32.922 33.1666 19.82 -10.1122 +7462 4 14.9257 27.349 33.4618 -9.56175 -2.66902 -6.75133 +7463 4 13.49 26.8422 33.5082 -21.5238 -13.7689 15.9353 +7464 6 31.6534 35.7886 21.2701 -36.804 -37.663 0.546332 +7465 4 32.1208 36.3742 21.8378 9.4961 28.0075 13.3964 +7466 4 30.8651 35.4592 21.7961 25.8489 11.2411 -16.1565 +7467 6 54.2152 28.7064 16.8886 2.86275 11.2554 8.9719 +7468 4 53.522 28.534 16.2345 -0.160695 -4.94794 5.34414 +7469 4 54.0581 29.6054 17.2296 -4.68599 -7.1814 -6.41975 +7470 6 9.06113 5.28333 17.1437 22.8853 4.22723 -20.1716 +7471 4 9.91678 5.17464 16.6036 -37.1561 0.754494 23.2593 +7472 4 8.77829 6.22091 17.0709 7.89423 -13.2605 2.73354 +7473 6 29.6746 9.78112 26.5507 33.4729 -21.3737 16.6755 +7474 4 30.5187 9.26436 26.5785 -19.9088 14.0899 -1.39861 +7475 4 29.3838 9.79264 27.4752 -2.64272 0.36338 -0.771294 +7476 6 44.0224 31.1718 32.1785 -15.3292 -7.28341 -3.2168 +7477 4 43.2245 30.9732 32.7283 18.2556 6.42044 -7.39667 +7478 4 44.6106 31.7763 32.6435 0.791193 1.46174 13.5451 +7479 6 53.5017 3.62335 25.1421 -16.9806 -9.67341 -1.19546 +7480 4 54.1073 4.37139 25.2408 5.33888 -0.871569 -8.36925 +7481 4 53.4976 3.25444 24.2353 14.6771 10.8199 10.1585 +7482 6 12.4523 22.8699 3.37515 20.8696 32.0548 51.3092 +7483 4 12.8715 22.0381 3.24611 3.69599 -28.8916 -15.1378 +7484 4 11.7545 23.0169 2.77653 -28.9409 -2.61743 -32.5554 +7485 6 39.4163 29.6883 0.716973 23.965 14.7498 -4.51132 +7486 4 39.9876 29.0776 0.254063 1.0023 1.05593 -7.22278 +7487 4 38.7356 29.138 1.03498 -27.9991 -12.2746 11.9106 +7488 6 13.7523 37.8126 23.0391 19.0421 33.8918 15.0049 +7489 4 14.5819 38.1972 23.3968 -5.92503 -31.5844 -9.82397 +7490 4 13.2717 38.649 23.0641 -23.8611 -10.9328 -14.9892 +7491 6 33.3489 41.2294 0.00543 12.0778 19.0207 4.12226 +7492 4 33.8966 0.076279 41.545 -17.8654 -16.3366 26.9287 +7493 4 33.5442 41.0956 0.968664 -4.79835 4.63337 -24.688 +7494 6 15.7246 3.52046 6.32841 10.9162 -8.85937 41.3038 +7495 4 14.9211 3.23468 6.78447 -0.787572 2.77727 3.3355 +7496 4 15.4617 3.69817 5.45032 -11.5336 7.63209 -33.5323 +7497 6 27.7759 30.762 5.08277 5.52432 -34.0682 -16.3389 +7498 4 28.5998 30.6312 5.57248 -10.7862 7.58152 2.34054 +7499 4 27.6688 29.856 4.68367 -5.5152 22.3618 6.77689 +7500 6 13.3283 7.58248 23.3427 28.3072 -1.43357 14.0598 +7501 4 14.1858 7.86415 22.9596 -10.8574 -4.57961 9.77565 +7502 4 12.7328 7.50745 22.6198 -18.1881 0.025746 -17.8687 +7503 6 38.3062 37.3234 27.9933 -3.63803 -3.21002 47.0561 +7504 4 38.1692 37.3862 27.0673 7.32148 -0.46048 -39.7323 +7505 4 39.0245 36.7163 28.2248 2.26391 -1.88339 -8.27891 +7506 6 35.8197 12.5511 12.093 -4.81482 -18.6185 14.0356 +7507 4 35.6024 11.6096 12.0486 2.81432 1.21601 -0.921604 +7508 4 36.2712 12.7262 11.2865 10.3444 9.98072 -18.0035 +7509 6 52.1161 23.0926 41.2793 27.7225 -3.87143 -59.8556 +7510 4 52.4049 23.0393 40.2964 5.44511 3.0042 51.4604 +7511 4 51.1968 22.9093 41.149 -26.7248 -2.75497 17.7375 +7512 6 39.5495 11.6692 16.6079 -1.17202 -14.5197 -14.1262 +7513 4 39.7784 10.7494 16.7482 7.99576 -7.98247 -12.1867 +7514 4 39.4663 11.9292 17.5115 -4.38422 20.0879 20.6825 +7515 6 0.676885 9.01905 7.96736 13.1741 22.7352 -22.4375 +7516 4 54.8016 8.92404 8.29683 -40.226 7.08621 2.19233 +7517 4 1.10058 8.31451 8.38908 28.7575 -30.4684 16.9583 +7518 6 42.3311 28.7401 39.4661 13.4879 80.877 11.2525 +7519 4 41.6603 28.5849 40.0851 -34.7426 -11.2721 27.5092 +7520 4 42.5519 27.921 39.1558 20.2132 -66.4303 -37.3003 +7521 6 38.7411 30.2829 16.2738 12.7671 5.32399 18.4704 +7522 4 38.9183 29.8748 17.1496 -6.87016 4.31697 -11.6029 +7523 4 39.4059 31.0046 16.2472 -14.9795 -12.5163 -3.03567 +7524 6 7.58764 18.0405 0.648325 -47.6574 -19.7672 20.3632 +7525 4 7.12731 17.6217 1.42737 12.1211 9.19751 -27.5752 +7526 4 8.47251 18.0259 0.938181 42.7013 4.4664 8.86021 +7527 6 33.7296 34.5938 24.1405 -3.484 -2.51034 -8.30179 +7528 4 33.5251 35.3309 23.5532 1.13599 -1.72579 4.26838 +7529 4 33.8994 34.9649 25.0137 6.47563 -1.63099 1.09862 +7530 6 16.0166 40.0494 39.5956 -28.3908 0.329345 -1.37751 +7531 4 16.9382 40.2323 39.4336 17.0381 0.329941 -6.23981 +7532 4 15.5262 40.0524 38.7513 12.3223 -0.591958 2.13513 +7533 6 4.49229 37.1333 21.8385 27.3085 -52.2253 -58.5501 +7534 4 4.66683 37.716 22.5264 18.8147 38.5231 40.56 +7535 4 5.37915 36.8768 21.3985 -41.7208 12.465 14.7942 +7536 6 39.2691 20.1288 31.3316 -12.2203 -9.20146 -18.9279 +7537 4 39.1503 20.9416 31.8094 1.95478 16.2675 16.373 +7538 4 38.6746 20.1785 30.5607 4.99665 9.53371 7.24081 +7539 6 28.5508 6.16368 32.0494 2.8072 -5.52183 -6.01527 +7540 4 29.3622 6.49582 32.4253 9.65206 -4.8896 7.96618 +7541 4 28.0782 6.98121 31.874 -4.3704 -0.58129 1.95425 +7542 6 9.33595 11.3298 38.1871 -32.8874 9.84086 11.8913 +7543 4 8.64445 12.0594 38.2922 21.8008 -26.7714 -10.0524 +7544 4 8.88851 10.5546 37.784 7.69784 20.5749 -6.72048 +7545 6 41.6095 10.4782 6.86111 8.23897 -6.62675 34.9169 +7546 4 41.7694 10.1037 7.78655 -4.1265 15.4661 -32.721 +7547 4 41.7821 11.4382 6.90291 -3.49967 -11.9299 -5.09907 +7548 6 3.12867 28.1157 17.6206 15.6267 -45.6796 29.9202 +7549 4 2.63816 28.6493 17.0564 -29.7899 29.6493 -43.0934 +7550 4 3.59757 28.7421 18.155 7.53462 9.15161 11.5693 +7551 6 39.3499 12.2397 19.2529 -23.7838 14.9837 13.9357 +7552 4 39.2457 13.2286 19.3464 7.91877 -27.4185 3.68816 +7553 4 38.6075 11.8387 19.7677 15.6586 5.94778 -12.3856 +7554 6 2.78491 9.11686 31.712 -26.5503 -22.4732 34.9375 +7555 4 3.2978 8.41451 32.2045 -9.27186 19.8876 -17.5091 +7556 4 3.27525 9.5282 31.0263 27.6548 6.40843 -16.0242 +7557 6 47.0993 34.3062 24.1668 40.213 25.5871 3.96938 +7558 4 47.8652 34.9011 23.9742 -8.40565 -28.0457 9.8184 +7559 4 46.4391 34.8642 23.795 -37.1496 -1.08965 -6.28687 +7560 6 41.29 35.6184 9.54316 -30.0867 29.8286 7.21591 +7561 4 40.3249 35.7138 9.72984 17.4159 -14.0538 -3.31523 +7562 4 41.5907 36.542 9.70742 6.71087 -21.892 -10.0971 +7563 6 20.4656 31.4513 3.14505 -29.4444 2.15246 21.5865 +7564 4 20.9799 31.2087 3.9226 8.79014 -0.482357 -2.15716 +7565 4 19.5517 31.5947 3.51954 23.5031 -1.57475 -20.844 +7566 6 33.2192 17.965 24.7971 19.8065 25.0952 18.1835 +7567 4 34.1598 18.0267 25.093 -16.2559 -11.4614 -7.96855 +7568 4 32.9244 18.9016 24.8301 -6.14071 -21.8705 -2.46334 +7569 6 40.1545 39.892 35.7566 -26.4952 1.03865 35.1005 +7570 4 39.554 39.7115 35.0283 3.12548 3.08468 -2.58895 +7571 4 39.5538 40.0617 36.55 23.7339 -1.54775 -30.4418 +7572 6 4.86493 34.7165 16.5037 -1.18866 4.83191 -8.79653 +7573 4 4.98021 35.6639 16.3239 -2.48039 -7.07182 -3.79473 +7574 4 5.57973 34.27 16.0245 9.17482 -2.77359 5.31354 +7575 6 19.1203 11.0308 26.5475 4.8369 12.9311 -1.38474 +7576 4 19.2948 10.8261 25.6303 -10.7878 -2.53157 -9.81197 +7577 4 19.6222 10.3806 27.0285 -0.932765 -12.0852 11.9627 +7578 6 54.013 13.9266 34.7866 19.735 -12.4153 18.0126 +7579 4 53.1377 14.0488 35.1524 -10.4928 -1.09871 -13.0068 +7580 4 53.982 14.1469 33.8595 -3.66316 10.2302 -11.2602 +7581 6 1.83695 20.649 5.20524 25.5491 14.9074 -17.0883 +7582 4 1.35705 19.8566 4.90021 2.5306 9.60758 -2.11708 +7583 4 2.48138 20.9466 4.48633 -27.5057 -15.388 16.1855 +7584 6 22.2484 0.089789 14.2543 15.3573 -11.1234 0.0573231 +7585 4 21.4821 0.622149 14.4313 -9.66168 8.29964 10.305 +7586 4 22.7606 41.8363 15.0657 -14.7435 5.42194 -5.09127 +7587 6 4.9437 7.03924 24.7311 13.2528 -2.19763 7.32506 +7588 4 4.13251 7.3412 24.2993 4.98795 -3.92941 -4.4547 +7589 4 5.31694 6.26419 24.274 -9.7854 5.58222 5.45409 +7590 6 41.4768 20.8727 34.9433 -10.8141 32.3245 17.6117 +7591 4 42.0721 20.1596 35.0936 18.2074 -21.2429 -2.25611 +7592 4 41.5511 21.3995 35.7803 -3.93981 -14.5735 -18.4651 +7593 6 28.2063 1.73787 31.7361 2.56856 -6.63991 -21.6427 +7594 4 27.5833 1.04583 32.0206 5.931 11.5306 2.70007 +7595 4 28.427 2.28487 32.4907 -6.15569 2.19681 12.1249 +7596 6 16.8959 27.3728 36.9936 3.36683 -9.46076 -21.7251 +7597 4 17.1861 28.0765 36.4018 -0.835984 6.87178 9.62195 +7598 4 17.1491 26.5677 36.4964 -8.72142 5.45523 11.8618 +7599 6 26.8172 38.095 8.33253 -7.04389 15.4319 43.7153 +7600 4 26.4231 38.1886 9.22965 13.1827 16.4204 -18.9623 +7601 4 26.752 37.1697 8.26194 2.82704 -45.8494 -18.5449 +7602 6 26.6605 33.8021 23.2109 -14.7721 -8.40788 6.86704 +7603 4 27.1437 33.2455 22.6071 1.71839 -3.83047 -13.3917 +7604 4 27.3181 34.0928 23.8234 13.6598 11.6313 12.8928 +7605 6 10.2089 27.1103 30.2249 26.5091 -20.839 -19.8889 +7606 4 10.2296 28.0525 30.305 -4.35446 23.414 7.17464 +7607 4 10.909 26.9135 29.5485 -17.3927 5.996 19.4297 +7608 6 47.8678 12.6068 5.01236 10.3402 17.2727 14.3835 +7609 4 48.2471 13.4466 5.34357 -15.5974 -13.1618 -9.91905 +7610 4 48.2827 11.9587 5.58273 0.760146 -12.24 2.37579 +7611 6 53.3401 24.5564 22.1447 -33.4845 3.13007 15.4457 +7612 4 53.2868 24.6175 23.1082 -8.50106 -5.88574 1.47389 +7613 4 54.2491 24.6404 21.954 37.9576 4.9603 -12.0283 +7614 6 29.4115 10.751 19.3682 47.3718 16.1602 -3.46693 +7615 4 29.23 9.95501 18.9095 -1.62259 -22.6341 -18.5903 +7616 4 28.6164 10.8767 19.816 -47.8248 15.8998 30.722 +7617 6 39.4772 14.9486 19.552 50.4126 11.9025 42.2912 +7618 4 40.3976 15.2789 19.8627 -47.7598 -21.1435 -8.50237 +7619 4 39.4723 15.2512 18.6704 -12.4406 15.8155 -35.6919 +7620 6 32.8813 15.9868 22.8125 3.47488 17.0872 -31.9433 +7621 4 33.0166 16.4922 23.6113 -1.39335 7.20309 14.6349 +7622 4 32.7144 15.0846 23.0256 -4.37432 -22.045 19.0968 +7623 6 30.558 1.96704 21.5074 2.70654 -4.91402 -0.473851 +7624 4 30.6739 2.00523 22.4671 5.88049 3.20632 -1.97238 +7625 4 31.3728 1.59666 21.1136 -11.8747 6.17773 7.16567 +7626 6 0.976021 12.0022 3.31788 -2.33791 2.9975 -11.3542 +7627 4 1.23381 12.945 3.27167 -8.13702 -10.1344 5.41434 +7628 4 1.05317 11.6593 4.21576 7.83216 6.74936 8.77967 +7629 6 32.1417 30.4028 20.7928 -10.9162 7.90477 -12.8705 +7630 4 32.9583 30.6218 20.3315 4.32484 3.35409 -0.814586 +7631 4 31.4267 30.7883 20.2371 10.7836 -11.8724 10.7529 +7632 6 5.37233 35.5196 8.9984 1.65786 -0.655334 17.0686 +7633 4 5.15633 35.7733 8.10502 -8.52999 -6.98357 -10.434 +7634 4 4.86772 34.7263 9.2434 -1.9757 2.02155 -6.9424 +7635 6 49.9125 13.0387 32.1973 27.4626 15.6741 -16.8517 +7636 4 50.6053 12.9182 31.4733 -26.2683 -0.306922 26.3637 +7637 4 49.2504 12.3613 32.0764 -3.75185 -11.6573 -0.304044 +7638 6 4.31386 24.093 1.57868 7.45772 -24.8618 -14.5348 +7639 4 3.64218 24.7342 1.7864 -13.9986 8.43803 -2.25361 +7640 4 4.01488 23.4668 0.872394 2.3276 24.3041 16.4513 +7641 6 44.1644 38.1215 12.3455 -22.0907 -25.3739 20.9172 +7642 4 43.5152 37.5597 12.8481 16.1408 4.83783 -17.5332 +7643 4 43.8688 38.9961 12.5721 5.21907 21.319 -3.3764 +7644 6 44.6817 17.3326 22.8013 48.0619 -4.56356 -9.07637 +7645 4 45.2902 18.0584 23.1498 -22.5072 -22.7727 -5.21409 +7646 4 45.2932 16.6008 22.4593 -20.015 30.0459 19.1644 +7647 6 20.3678 11.7042 19.6638 18.1083 -41.9451 -24.672 +7648 4 19.8947 12.3606 20.1264 -14.0753 36.8205 14.9866 +7649 4 20.5011 12.0109 18.7433 -0.799123 0.72776 10.7716 +7650 6 4.45477 15.3976 36.1886 1.65809 1.26145 11.9226 +7651 4 5.09661 14.6681 36.098 -4.75494 5.61497 -10.92 +7652 4 3.56051 15.0123 36.2095 4.93474 0.57137 -3.51241 +7653 6 44.8032 39.5214 30.1736 10.2403 3.65831 -28.7798 +7654 4 44.6649 39.352 29.2044 0.893291 -3.4354 28.9244 +7655 4 44.1834 39.0261 30.7164 -9.9549 -0.503639 -4.51595 +7656 6 30.0776 3.52093 11.3186 -8.111 -9.63673 -5.93937 +7657 4 30.5797 4.33725 11.0789 -10.9699 -19.7375 -4.73534 +7658 4 29.9808 2.85663 10.5812 14.022 21.906 10.2093 +7659 6 25.6241 24.8658 16.1333 6.68449 -9.57605 -29.1286 +7660 4 26.5694 24.8046 15.8818 -8.72523 1.1772 17.1704 +7661 4 25.5267 25.1318 17.0381 12.8553 5.85519 26.3055 +7662 6 36.8177 29.8487 20.6561 -37.5479 -3.0004 33.0202 +7663 4 35.926 30.1959 20.4157 18.2985 -1.907 -0.407745 +7664 4 36.6716 29.3784 21.5423 12.7247 15.2026 -39.3319 +7665 6 52.2186 17.0658 38.3042 -7.89215 -38.4825 28.5148 +7666 4 51.4916 16.4675 38.6484 24.7832 21.5941 -14.95 +7667 4 51.8247 17.6139 37.6469 -10.8917 8.73986 -12.7264 +7668 6 3.82879 23.6249 29.8747 0.0111461 24.9347 -0.194649 +7669 4 4.57266 23.2964 29.3507 7.82142 7.55197 5.89536 +7670 4 4.12107 24.4472 30.3626 -2.93665 -31.334 -6.69289 +7671 6 6.37221 19.8955 41.0814 -10.7405 10.6187 0.232117 +7672 4 6.67124 19.2607 41.7286 9.67887 -12.4754 3.81392 +7673 4 6.49825 20.7419 41.4991 -1.14685 10.1205 10.9238 +7674 6 28.9128 38.9237 35.3305 22.4394 21.6131 25.3888 +7675 4 28.4594 38.2476 34.8641 -13.9867 -26.2755 -20.0992 +7676 4 29.711 38.4973 35.7105 -10.7836 3.83713 -8.57645 +7677 6 1.06675 30.3059 34.4729 25.4378 -4.31804 35.0042 +7678 4 0.780778 29.8064 33.7399 -5.76855 -22.7951 -38.2413 +7679 4 0.490797 31.0506 34.5199 -18.1513 16.5028 -0.872558 +7680 6 26.4359 22.0299 20.4363 32.8101 13.5123 0.44111 +7681 4 27.364 22.3315 20.3938 -13.8894 -16.1779 0.0777322 +7682 4 25.9647 22.8561 20.3336 -19.4369 -2.2953 -2.32927 +7683 6 3.94837 18.6341 22.6823 32.7056 -17.0211 23.8668 +7684 4 4.7768 18.6814 23.2391 -24.3494 -8.73456 -16.7413 +7685 4 3.72444 19.5457 22.6416 -13.4357 33.3979 -9.86072 +7686 6 6.89585 39.3162 26.9832 -46.5714 7.68979 7.72716 +7687 4 6.93923 40.0377 27.612 28.7888 3.33438 12.9127 +7688 4 5.92214 39.2413 27.0287 16.4173 -5.75108 -11.0421 +7689 6 43.9872 41.7521 26.5322 17.8857 -12.0416 -16.5154 +7690 4 43.9509 0.2718 27.3768 -8.40653 9.77536 19.5266 +7691 4 43.1315 41.809 26.1188 -22.0408 9.50446 -3.00799 +7692 6 31.7113 29.5746 16.987 -20.6637 1.93471 5.13032 +7693 4 31.02 28.863 17.0135 12.5534 15.6398 -7.64726 +7694 4 31.2508 30.4156 17.2234 10.2038 -24.3383 2.42367 +7695 6 46.2561 10.9612 15.5385 0.577538 -38.7584 22.3134 +7696 4 45.3251 10.7213 15.4484 -5.02058 7.03855 -0.171485 +7697 4 46.6569 10.0824 15.7727 -2.20865 28.2857 -11.3723 +7698 6 36.5827 15.0435 25.8168 31.2067 4.61936 9.12499 +7699 4 37.3875 15.5118 26.1911 -33.209 -18.98 -14.6655 +7700 4 36.1295 14.6889 26.5897 -4.0863 -6.05063 3.58839 +7701 6 47.2722 22.6647 6.13576 -8.17133 27.0247 -35.749 +7702 4 46.6204 23.3224 5.77393 14.8224 -22.4366 13.8178 +7703 4 46.9842 22.4705 7.01441 -4.98592 -2.25738 16.061 +7704 6 27.5378 39.6651 17.8024 -2.94112 10.9701 -10.3343 +7705 4 26.5953 39.7232 17.618 -8.53785 1.10642 -8.0722 +7706 4 27.5664 39.1005 18.5557 5.38052 -12.9364 18.2146 +7707 6 14.0357 27.9675 36.8848 11.7171 -39.9071 2.25396 +7708 4 13.4367 27.1833 36.8225 11.7441 28.4062 -4.63591 +7709 4 14.9372 27.5486 36.8957 -17.1932 18.8386 1.76957 +7710 6 33.7684 13.0304 13.8649 26.1794 -24.2655 -33.187 +7711 4 34.6252 12.938 13.363 -28.3858 22.7045 20.1179 +7712 4 33.4338 12.1329 13.7478 -6.61414 4.24237 14.4002 +7713 6 3.3826 17.477 1.97134 -12.4208 -32.1468 -36.6933 +7714 4 2.99872 16.7111 1.40376 19.9781 39.313 29.0042 +7715 4 3.44044 18.2025 1.33186 0.336883 0.1642 8.16047 +7716 6 27.5407 2.76347 36.4361 37.1152 10.6125 -5.75272 +7717 4 28.1274 2.95293 35.6781 -8.18971 -2.06925 12.0999 +7718 4 26.7696 2.41682 36.0063 -15.232 -6.73967 7.66134 +7719 6 21.3092 1.20818 18.7198 27.6808 -56.7894 17.4302 +7720 4 20.9088 2.03925 18.6129 -17.8717 42.912 1.2548 +7721 4 21.1846 0.863131 19.6413 -10.5106 12.8119 -18.3621 +7722 6 11.8887 16.6751 29.3062 -13.3787 -14.7829 9.57092 +7723 4 10.9992 16.5416 28.8882 19.0949 3.10928 11.6713 +7724 4 11.8781 16.1991 30.1864 -3.15773 18.3703 -25.9576 +7725 6 15.9606 29.4505 29.6321 19.1231 40.0535 19.8704 +7726 4 16.8787 29.2659 29.409 -1.79459 -0.812108 -5.15406 +7727 4 16.0576 30.3074 30.1528 -10.887 -31.0851 -11.0284 +7728 6 42.9296 7.03459 4.51333 33.3286 4.63812 8.33203 +7729 4 43.4321 7.52085 3.82302 -14.3213 -8.56549 9.51251 +7730 4 43.6462 6.74019 5.1384 -26.8219 -5.28882 -15.1101 +7731 6 46.4281 26.3352 18.5118 -29.5226 20.9834 -10.3716 +7732 4 46.6343 27.1839 18.9751 -0.829481 -30.2492 -9.82569 +7733 4 45.6684 26.5824 17.9287 20.9241 -8.5113 7.46212 +7734 6 26.8394 31.9326 30.1088 25.5924 -16.6135 -32.4851 +7735 4 27.2107 31.0232 29.8435 -20.3392 35.4128 12.4615 +7736 4 26.6802 32.4017 29.2373 1.48159 -21.8349 29.7067 +7737 6 19.4878 37.6142 31.2562 -14.4543 3.58951 24.8148 +7738 4 19.156 36.8698 30.7235 -3.28844 3.66685 11.8368 +7739 4 19.1019 37.6358 32.1884 8.87174 -10.6544 -29.6345 +7740 6 52.3726 32.7139 12.8078 14.0751 37.5782 -32.6023 +7741 4 51.9367 33.0602 12.0031 -5.44932 -19.1877 9.81768 +7742 4 53.2329 33.1776 12.7347 -13.6236 -17.9256 14.0183 +7743 6 6.74161 9.28353 24.0307 -13.1667 -36.0519 9.75632 +7744 4 6.38029 9.61276 23.1997 0.718458 -3.76261 -6.90188 +7745 4 6.16941 8.51095 24.2946 11.6474 19.2019 -8.42102 +7746 6 39.7455 39.5612 25.4988 -8.346 1.54154 -0.59194 +7747 4 39.7035 38.6168 25.2826 0.975023 6.38379 0.651723 +7748 4 38.8484 39.7767 25.8082 2.0142 -6.85885 -0.770105 +7749 6 24.0762 14.0053 21.1456 13.3165 -18.5501 -35.6859 +7750 4 23.5798 13.5675 21.8237 -9.9014 -1.44375 19.5869 +7751 4 24.3047 13.2647 20.5221 -3.72657 29.1491 15.9401 +7752 6 5.19759 41.7876 24.8616 10.5329 -30.3401 13.9713 +7753 4 5.96107 0.070496 25.4117 5.01198 -1.48177 -8.04364 +7754 4 4.80364 0.70791 24.6471 -6.87058 19.426 -10.6286 +7755 6 42.3635 20.8692 21.2747 32.7502 -34.6644 -10.1673 +7756 4 42.4242 20.4785 22.1458 -3.583 2.66194 10.2144 +7757 4 41.7418 21.5604 21.318 -29.6652 28.4695 2.24145 +7758 6 48.2477 15.3659 33.5923 1.80889 -1.28345 12.5443 +7759 4 48.6164 14.6993 32.9992 0.330488 0.612282 -4.05403 +7760 4 47.6342 15.9182 33.1009 -4.13716 0.340872 -13.8372 +7761 6 46.021 38.2915 16.5867 23.3569 13.4435 24.034 +7762 4 46.6714 37.7063 17.0526 -15.1447 15.3639 -15.4724 +7763 4 46.2171 39.2064 16.9307 -10.1858 -20.2136 -16.2853 +7764 6 4.64649 28.484 21.3661 -49.4423 -36.8464 -34.122 +7765 4 5.0061 28.857 22.1388 17.5694 9.2675 37.6073 +7766 4 4.11403 27.6656 21.6036 24.8595 24.6655 -3.1651 +7767 6 20.5601 15.1658 18.389 17.6685 -18.4833 12.4376 +7768 4 20.0269 15.9148 18.1339 -10.4277 9.01273 0.992097 +7769 4 20.1375 14.696 19.1318 -1.87864 11.9594 -2.12399 +7770 6 16.2536 13.648 17.4664 -31.6255 -3.12789 -19.3987 +7771 4 16.1444 14.6075 17.6118 2.65347 -13.1818 -8.15029 +7772 4 15.6032 13.3943 16.7283 22.0135 11.6863 31.5082 +7773 6 52.4969 30.9511 18.1582 10.5176 -22.8935 27.2955 +7774 4 52.1187 31.5845 17.5724 -17.5669 13.4893 -21.7562 +7775 4 51.7599 30.5669 18.6706 14.518 10.6779 -8.97027 +7776 6 24.417 1.73185 15.7818 -6.46311 -4.24469 33.4298 +7777 4 24.2563 1.19981 16.5985 3.98325 2.24538 -18.7421 +7778 4 24.1038 2.61269 16.0335 4.13298 0.832539 -9.96215 +7779 6 23.8696 5.09384 31.0808 18.8621 -40.8234 -26.8653 +7780 4 23.8491 5.89936 31.5593 0.144588 30.2314 14.3891 +7781 4 24.8063 4.82715 30.9043 -17.3015 12.7186 6.18451 +7782 6 29.664 30.9246 0.393748 19.8337 -4.81556 23.0674 +7783 4 30.503 30.586 0.018652 -21.3617 6.75777 -1.54054 +7784 4 29.144 31.3327 41.6109 -5.17979 -0.628515 -14.2195 +7785 6 32.8496 37.8945 22.5158 10.0753 4.77658 10.1953 +7786 4 33.692 38.178 22.1563 2.67507 -3.41774 -7.7275 +7787 4 32.953 38.1222 23.4459 -10.6691 2.21895 5.00606 +7788 6 16.4801 17.3789 33.7607 -9.23434 -4.14589 -23.771 +7789 4 15.9446 17.8653 33.093 7.5539 3.01496 23.5583 +7790 4 17.136 16.9338 33.2029 1.0053 3.7812 3.66748 +7791 6 9.22576 13.3955 27.544 21.8484 -6.91303 -4.28818 +7792 4 8.36976 13.4851 27.1157 -15.2219 0.444174 10.4645 +7793 4 9.14931 12.9772 28.4181 -9.36318 7.36421 3.71477 +7794 6 43.4776 7.7356 17.2334 -9.59035 3.82748 19.1182 +7795 4 43.4092 7.74545 18.2218 0.501649 1.62452 -33.0026 +7796 4 44.4173 7.85634 17.0579 0.99974 -1.57098 -4.99047 +7797 6 22.314 24.3423 23.1668 -12.6246 5.51695 -1.93377 +7798 4 22.7955 23.5193 23.2443 6.83464 -10.1031 3.26418 +7799 4 21.5276 24.1384 22.6266 3.35813 5.31764 3.82921 +7800 6 26.0086 32.9187 32.7195 -0.756619 6.65713 -1.20686 +7801 4 26.2515 32.7095 31.8047 -0.82286 -4.52018 -0.557583 +7802 4 25.2078 32.4163 32.9092 -2.81033 -0.378904 -0.617388 +7803 6 16.9305 19.0463 7.44765 14.0068 18.7364 -6.96389 +7804 4 16.3855 19.2981 8.21028 -2.47769 1.30563 -6.88861 +7805 4 17.0815 19.8512 6.87677 -9.59141 -23.4241 18.196 +7806 6 48.1118 14.458 27.5672 -1.70385 5.14823 10.3583 +7807 4 48.0423 15.1786 26.9235 1.90686 -4.78611 -1.19899 +7808 4 48.0875 14.8765 28.4507 4.89589 -0.740891 -11.823 +7809 6 52.3863 41.7399 11.1185 2.41988 14.2085 23.7397 +7810 4 52.3863 0.193993 10.2459 -4.45976 10.8931 -22.0542 +7811 4 52.6887 0.557857 11.7005 -5.56281 -10.4239 -7.84704 +7812 6 36.3311 6.93589 12.7094 -2.38398 9.53491 -1.97617 +7813 4 36.3789 7.90344 12.827 -2.48918 -10.7733 3.15906 +7814 4 37.2588 6.6822 12.6726 5.22435 -7.00461 -0.877062 +7815 6 8.24215 20.3216 16.6719 4.98767 -5.10439 -5.65687 +7816 4 8.08588 19.3952 16.4038 -4.3079 5.82994 10.8424 +7817 4 9.2046 20.4438 16.7199 -1.30961 -3.63404 -4.19262 +7818 6 28.7954 40.3113 12.828 -13.6179 6.23593 21.4452 +7819 4 29.5192 40.3706 12.2287 20.8327 -7.3113 -16.8089 +7820 4 28.5554 39.3777 12.9053 -3.26344 4.60902 -2.65931 +7821 6 18.1473 11.8343 16.9395 -0.80483 -16.2761 12.6256 +7822 4 17.6848 12.6388 17.2294 4.62203 -2.59462 -3.9508 +7823 4 19.0947 11.9922 16.9221 7.13726 16.095 1.27241 +7824 6 30.8869 17.4142 21.504 -52.7305 12.2285 -31.3088 +7825 4 30.1482 16.8222 21.1884 27.1221 10.2955 22.0665 +7826 4 31.6253 16.8731 21.7262 19.9221 -18.6281 13.9623 +7827 6 34.8012 19.4194 37.9626 16.1869 22.0253 -15.6613 +7828 4 34.8979 20.1386 37.2822 -2.41662 -18.1877 20.3873 +7829 4 34.2105 18.7604 37.6043 -6.15487 -8.04615 -10.7113 +7830 6 35.8208 16.8923 29.2032 22.3367 20.7443 33.8648 +7831 4 36.613 16.5252 29.6466 -9.20578 0.119567 -6.22754 +7832 4 35.5382 16.2441 28.5922 -11.4717 -30.451 -21.7041 +7833 6 3.04279 32.2854 6.33929 -26.9238 12.3825 -4.69033 +7834 4 2.12647 32.146 6.0594 1.42689 6.59766 6.64942 +7835 4 3.42261 31.4611 6.08203 25.9982 -20.506 -0.598367 +7836 6 26.7966 41.6596 10.1464 32.6739 -10.8326 9.81865 +7837 4 27.6955 41.4226 9.79016 -25.5431 4.71255 4.81996 +7838 4 26.9918 0.01593 11.0584 -5.4334 2.64263 -3.14356 +7839 6 52.266 24.562 24.8685 -9.42886 0.421982 -6.72882 +7840 4 51.3046 24.7615 24.9057 17.7877 -5.82089 5.23086 +7841 4 52.6568 24.8699 25.6923 -4.67896 5.24225 9.60646 +7842 6 22.6938 22.6511 33.5751 -3.71591 7.58927 38.5179 +7843 4 23.2073 23.1628 34.2375 -1.81825 -3.74423 -24.5931 +7844 4 21.9227 22.4274 34.1227 -1.3969 -6.37714 -14.1968 +7845 6 10.6508 14.2453 33.0462 38.3111 -19.1724 1.31243 +7846 4 10.5904 14.9583 32.4175 -11.7628 10.624 -9.61146 +7847 4 9.79743 14.0525 33.3881 -28.4056 0.15536 2.16046 +7848 6 21.8963 10.8464 11.5207 26.0054 2.65771 10.2946 +7849 4 22.8204 10.615 11.7238 1.04479 5.32162 -7.74354 +7850 4 21.5123 10.8483 12.397 -14.7134 -4.5627 10.8449 +7851 6 38.3602 6.02493 25.8481 -1.65407 -6.16467 0.326828 +7852 4 38.011 6.16356 26.7557 4.19059 11.4538 -13.8011 +7853 4 38.4332 6.8537 25.3449 -2.0709 2.94932 12.5244 +7854 6 30.9335 26.6426 38.5759 12.2579 -6.52521 -50.146 +7855 4 30.9725 26.4832 39.4983 -1.12433 -12.3748 34.5417 +7856 4 31.1634 25.7976 38.1184 -10.2303 12.0451 18.6771 +7857 6 30.1758 14.6176 35.4883 -28.0954 45.5198 -22.6945 +7858 4 30.377 15.4621 34.9933 16.3957 -28.3235 8.82257 +7859 4 29.2055 14.6893 35.4544 11.1506 -16.8188 10.9927 +7860 6 12.5393 37.2199 16.9523 -39.8589 -5.36999 -7.27655 +7861 4 12.8749 37.9509 17.4338 22.3846 22.4284 20.6781 +7862 4 13.1653 36.5135 16.9845 23.2041 -13.3789 -0.375674 +7863 6 27.4265 21.5607 37.7225 20.8747 -12.9562 -0.181201 +7864 4 26.9326 21.725 36.9211 -12.0211 3.79264 -7.84561 +7865 4 27.0206 21.994 38.4656 -12.5008 8.35973 2.85409 +7866 6 29.6119 18.3909 12.6766 5.02953 -16.5769 27.1188 +7867 4 29.5217 18.1084 13.6179 -1.01954 6.11509 -19.9302 +7868 4 28.7057 18.4542 12.3734 -9.03627 4.70036 -1.08008 +7869 6 2.35849 15.6559 0.172343 -13.1317 26.5324 40.4931 +7870 4 1.57628 15.538 41.5798 -33.9312 2.46749 -10.4392 +7871 4 2.94928 15.1153 41.6306 46.9044 -35.3027 -23.6199 +7872 6 17.8239 25.728 4.21905 -37.6117 -8.49993 -31.7596 +7873 4 16.8718 25.6243 3.8952 33.4499 1.9374 22.526 +7874 4 18.2969 25.7387 3.3671 7.88894 5.9968 18.5236 +7875 6 41.8048 11.1855 20.2736 -2.74436 -4.31591 -6.39865 +7876 4 42.499 11.3266 19.6063 -2.31748 -7.213 6.47037 +7877 4 40.9812 11.3277 19.7997 -4.16553 7.78699 0.129723 +7878 6 38.0436 18.3822 24.0291 -8.03771 -8.75406 0.916934 +7879 4 38.3881 19.1147 24.5363 7.93091 8.32946 7.65245 +7880 4 37.8775 18.7197 23.1534 1.15748 3.59885 -9.88254 +7881 6 4.13949 13.9245 33.751 32.8429 -54.5446 -5.73928 +7882 4 3.27676 13.674 34.0388 -19.3763 3.63281 4.9893 +7883 4 4.61955 13.0097 33.6871 -20.752 50.0513 -2.76975 +7884 6 19.1955 19.1942 26.4999 -2.68794 -13.6734 16.0889 +7885 4 19.5301 20.0447 26.2113 2.49975 9.05121 -5.4902 +7886 4 18.8802 18.7176 25.7363 0.91839 -0.338605 -10.966 +7887 6 22.4654 26.212 25.3377 -43.9819 -31.3945 15.8492 +7888 4 22.341 25.462 24.7348 6.987 2.92742 -4.90062 +7889 4 23.2684 26.6111 25.1223 47.0594 15.091 -19.0516 +7890 6 48.8212 32.07 32.5598 -32.6217 13.0764 9.49579 +7891 4 48.8519 31.1339 32.3903 9.77015 -16.5586 -2.94571 +7892 4 49.6142 32.4858 32.2593 19.8009 3.1546 -7.06015 +7893 6 25.2092 18.0177 27.0119 4.84672 -18.7822 -3.15467 +7894 4 24.5216 17.4674 27.4199 2.41306 12.0417 3.55819 +7895 4 25.6695 17.4202 26.3966 -2.25094 9.61905 1.21472 +7896 6 1.75029 41.5558 24.9373 10.8929 -9.66126 -16.5331 +7897 4 1.94143 40.8029 24.3062 -11.1729 27.8661 22.017 +7898 4 1.33214 0.330238 24.3814 7.15774 -16.2959 10.6574 +7899 6 18.6827 11.7655 10.8523 -12.8723 -21.6642 16.1997 +7900 4 19.5636 11.9042 10.4948 -5.12175 -0.337419 -4.96303 +7901 4 18.6779 10.8452 11.2231 -2.76434 23.9208 -10.2934 +7902 6 45.6216 16.5622 4.85345 35.2391 7.72621 -8.96994 +7903 4 46.5826 16.2921 4.84248 -29.2944 1.01327 2.32041 +7904 4 45.6571 17.5026 4.56372 -8.00263 -16.2723 6.75488 +7905 6 40.6693 36.3938 24.0175 15.8353 8.34465 -33.37 +7906 4 40.8833 36.7626 23.1096 -14.2319 -6.57786 31.0793 +7907 4 40.765 35.4388 23.9669 -2.25062 -4.28397 3.06966 +7908 6 32.2103 36.323 4.961 11.3673 -15.0032 -27.5021 +7909 4 31.6022 36.0041 4.27996 -13.8963 14.3234 5.17466 +7910 4 32.9864 35.7931 4.73143 4.05858 7.46319 17.1387 +7911 6 1.60869 14.6755 10.8061 -10.0389 6.06769 39.8197 +7912 4 2.33356 15.3221 10.9109 -7.21973 -7.23845 -0.707439 +7913 4 1.19104 14.6475 11.7231 10.7485 2.93157 -30.114 +7914 6 35.0001 14.2727 28.079 63.2852 10.3217 34.449 +7915 4 34.8812 14.1453 29.0533 -4.19424 -2.10072 -23.3494 +7916 4 34.1798 14.2655 27.6589 -51.5469 -5.32036 -14.2309 +7917 6 54.7125 6.11605 21.8555 -14.0361 -8.25377 2.86163 +7918 4 53.7845 6.02557 22.1597 12.8111 1.82594 -4.22103 +7919 4 0.03027 6.89073 22.319 4.64766 10.0402 5.34703 +7920 6 31.7713 16.925 27.3783 -6.86907 -7.88471 17.2493 +7921 4 30.8352 17.1376 27.29 -7.38275 1.84485 -8.02972 +7922 4 32.1916 17.1776 26.567 8.49209 11.7792 -21.4891 +7923 6 14.465 28.0197 11.093 -4.59026 -39.5121 13.6529 +7924 4 14.1257 28.8224 11.4501 -8.46011 24.0779 0.0563038 +7925 4 14.7692 28.1802 10.1981 4.52198 5.50754 -5.24146 +7926 6 35.6475 19.4845 18.3155 9.57103 -1.809 -3.39748 +7927 4 36.1727 19.3545 19.1113 -4.74674 6.51425 2.74698 +7928 4 35.0476 18.7267 18.3208 -0.78661 10.9943 -3.1182 +7929 6 0.909574 12.7326 15.4512 -4.00403 -44.3255 -0.361194 +7930 4 0.713888 11.7498 15.2844 2.79491 38.2978 9.54583 +7931 4 1.42535 12.7402 16.2831 -6.10996 -1.10113 -5.97882 +7932 6 52.7151 14.8297 20.9852 -8.18072 -78.4028 12.8764 +7933 4 52.2089 13.9625 20.7908 19.9141 35.1606 18.4317 +7934 4 52.3599 15.4219 20.3591 -8.09633 28.1752 -16.3986 +7935 6 7.5074 6.79303 13.6094 20.1749 -33.1825 -2.20484 +7936 4 7.51894 7.72815 13.8132 13.5555 7.5777 -3.02343 +7937 4 8.44355 6.42469 13.5879 -32.5694 21.0012 0.325521 +7938 6 12.8707 29.146 30.9458 -23.5578 15.3335 -40.981 +7939 4 12.9428 28.445 30.3111 -4.06483 -0.044806 -18.3112 +7940 4 13.2276 28.7127 31.6654 25.7046 -17.9249 62.7325 +7941 6 8.91318 29.991 35.6703 -0.0610651 3.14803 31.5119 +7942 4 8.887 30.0597 36.6571 13.1627 -14.4278 -23.4692 +7943 4 8.81345 30.9051 35.4106 0.983205 7.41015 -17.1111 +7944 6 29.2436 7.20633 5.57892 -54.0378 33.243 -15.4453 +7945 4 29.9077 6.6209 5.82325 37.3203 -38.0996 12.3519 +7946 4 28.4255 6.92245 6.05186 24.5111 10.6259 -6.90283 +7947 6 25.8948 9.2579 3.86177 -16.7921 -19.1399 -16.9328 +7948 4 26.6486 8.78935 3.46547 3.6066 2.83982 9.7025 +7949 4 25.146 8.75694 3.47524 9.6908 8.1243 10.3781 +7950 6 46.1591 19.5353 23.8511 81.1089 -3.44953 5.31324 +7951 4 47.0572 19.4192 24.3423 -46.5837 0.334518 -9.80273 +7952 4 46.5432 19.8542 23.0066 -21.4105 0.836057 1.37554 +7953 6 18.5926 35.3225 28.784 52.2521 -24.0621 1.05868 +7954 4 18.6271 36.1437 28.292 -9.91963 10.3291 -8.20284 +7955 4 19.5499 34.9756 28.7398 -42.866 14.0686 4.10052 +7956 6 27.9863 22.6413 32.202 21.6529 -11.7193 -18.2399 +7957 4 28.0891 22.9783 31.3009 1.03266 3.02954 6.56078 +7958 4 27.1414 22.9613 32.5068 -4.28354 -0.549074 4.96673 +7959 6 25.9903 18.4326 22.6797 -22.9747 -15.6034 11.3844 +7960 4 26.7869 18.8273 22.3692 24.9379 13.7229 -5.91644 +7961 4 25.7208 18.921 23.4832 11.724 -6.94511 -8.75168 +7962 6 31.1697 23.092 29.1693 -11.9745 -15.1316 21.2053 +7963 4 31.2077 22.141 28.9533 -3.34012 7.58841 -3.35467 +7964 4 31.7416 23.575 28.5808 9.8436 3.86516 -11.5721 +7965 6 36.6303 4.93142 0.48008 48.3 12.3871 -22.3067 +7966 4 36.6637 5.82298 0.895967 -3.77214 -15.5899 -6.86281 +7967 4 37.4556 4.91994 41.7793 -42.6939 0.501904 23.801 +7968 6 36.4828 20.995 10.0445 1.4409 16.9025 7.88029 +7969 4 36.442 20.1354 9.60774 -3.67605 2.90774 1.0232 +7970 4 35.8889 20.9899 10.8082 0.675338 -5.55749 -3.21659 +7971 6 50.6068 25.1826 18.3885 -34.0155 8.99756 4.28297 +7972 4 49.9165 24.7513 17.8483 3.12051 4.84127 10.9758 +7973 4 51.4426 24.9479 18.0312 23.0155 -7.64449 -5.94589 +7974 6 50.1857 39.6546 12.4249 -35.8487 -4.75972 18.1961 +7975 4 49.7435 38.8097 12.6589 9.38526 12.3917 -5.89531 +7976 4 51.0761 39.4561 12.2056 25.3285 -5.23538 -8.69122 +7977 6 30.5392 12.4112 4.81308 -24.6918 -8.37115 23.8709 +7978 4 30.0105 11.5821 4.90198 12.5687 16.0288 7.14 +7979 4 30.9611 12.2897 3.99028 20.9425 -4.88336 -30.4106 +7980 6 28.9507 15.4785 21.8764 2.88494 -37.77 16.9414 +7981 4 29.2026 14.5932 22.3105 -13.0637 39.016 -13.1967 +7982 4 28.2142 15.8194 22.4189 7.40001 -5.36107 -10.8423 +7983 6 14.0621 9.56364 16.9937 6.86557 -12.9325 3.68967 +7984 4 14.7638 8.91135 17.1437 -0.397896 3.39204 -3.97785 +7985 4 14.5001 10.412 17.0773 -1.84745 7.98018 -3.95086 +7986 6 4.48418 30.1793 11.8502 16.4679 -16.8356 33.0547 +7987 4 4.88144 29.8061 12.6848 -7.18701 8.62616 -23.9784 +7988 4 3.54784 30.2411 12.0492 -7.30801 4.11375 -9.31782 +7989 6 40.8925 8.06286 23.6531 -5.33465 -0.617655 -7.49645 +7990 4 40.8929 8.28602 22.6923 5.67883 -10.477 13.1878 +7991 4 40.7177 7.10184 23.7416 4.86142 9.55736 -10.8624 +7992 6 53.7474 35.0502 16.7091 9.64852 13.8526 -34.5004 +7993 4 53.4511 35.8404 17.1588 -1.68768 2.98716 11.3576 +7994 4 54.0332 35.3898 15.821 -5.01984 -16.258 24.672 +7995 6 53.7089 10.1864 20.3635 2.29909 -3.91508 11.8946 +7996 4 53.865 9.95358 19.435 -6.30341 10.2468 0.803923 +7997 4 53.074 10.9174 20.4153 4.1525 1.61451 -13.3956 +7998 6 4.58325 27.0727 7.79253 38.2121 26.3993 -10.0836 +7999 4 5.27724 26.393 7.80253 -10.2172 -9.80276 1.23658 +8000 4 3.71677 26.7514 7.92113 -24.69 -25.9094 6.50141 +8001 6 50.5074 22.5408 22.1421 -8.69376 -16.3879 19.9073 +8002 4 50.2488 23.2402 22.7623 5.11604 2.17524 -13.9015 +8003 4 50.7961 22.8564 21.2903 3.5618 14.8025 -7.32432 +8004 6 7.04732 27.2027 21.6256 -40.8926 -21.8944 23.9514 +8005 4 6.7035 26.7027 22.422 28.3929 12.8045 -18.4773 +8006 4 6.19014 27.4064 21.2095 22.0893 5.82121 -6.88916 +8007 6 23.8331 35.0488 16.5891 16.32 14.4309 46.4508 +8008 4 24.6955 34.7392 16.9507 -15.4311 10.68 -10.0146 +8009 4 23.6772 34.608 15.7848 -0.180345 -20.5093 -35.2233 +8010 6 5.99568 23.9111 3.91414 -16.1284 -13.3557 2.33299 +8011 4 5.47632 24.0272 3.08057 3.14343 -7.41418 20.837 +8012 4 5.41258 23.5631 4.6401 5.53308 9.77645 -18.8553 +8013 6 38.7285 25.0725 19.1284 6.5843 12.292 11.4002 +8014 4 38.8305 24.3279 18.5317 -0.433768 -14.0645 -4.65001 +8015 4 38.9527 24.8378 20.0476 4.74577 -1.1864 -10.184 +8016 6 12.9754 18.2903 10.6176 0.588158 -4.74371 -11.7219 +8017 4 12.1189 18.2831 10.1754 -4.50324 1.27903 -1.36841 +8018 4 12.8026 18.5801 11.5112 2.24696 5.46905 14.7352 +8019 6 38.0467 41.2366 21.1082 -14.4892 -16.6352 -5.66336 +8020 4 37.1721 40.8226 21.1941 10.2151 -2.13153 3.70269 +8021 4 37.8745 0.133442 20.6393 0.730193 23.6843 -6.95691 +8022 6 6.9767 22.8602 17.8447 -15.6268 -18.8158 0.81989 +8023 4 7.5707 23.5707 17.6602 21.732 18.7089 -7.75629 +8024 4 7.31556 22.0497 17.428 2.05587 4.83625 4.35773 +8025 6 24.1095 19.3932 12.3316 12.1602 -2.11517 -13.1018 +8026 4 23.8745 19.734 13.1953 2.64822 12.0925 0.881714 +8027 4 23.8476 18.4865 12.3899 -10.6841 -23.2361 -5.46211 +8028 6 44.2232 28.4408 4.82746 -1.7669 2.66578 -25.5607 +8029 4 44.2803 28.1144 3.91045 1.22274 -3.80694 10.7546 +8030 4 44.1446 29.3994 4.68927 4.81937 -0.158515 8.55 +8031 6 23.3113 8.29915 21.4219 -9.51684 27.1403 7.66167 +8032 4 22.936 9.22921 21.4746 15.7805 -27.4461 5.90598 +8033 4 23.1012 8.0569 20.5135 3.89809 -6.65443 -0.402871 +8034 6 14.3464 2.18773 18.5362 -23.516 16.4481 4.67993 +8035 4 14.2678 1.24418 18.6898 10.1474 -10.2606 4.48578 +8036 4 15.2445 2.40605 18.3047 18.9771 -8.71598 -6.68368 +8037 6 28.0424 31.9381 34.1184 1.44373 -10.4149 10.0158 +8038 4 28.467 32.321 34.8914 3.92062 5.65333 3.09761 +8039 4 27.2701 32.5111 33.9835 5.51879 -6.95928 -12.9635 +8040 6 53.345 24.6925 18.2818 -10.4918 -25.9433 -31.7967 +8041 4 53.4866 24.6975 17.3285 -0.882305 -10.6531 -2.1422 +8042 4 53.7306 25.5021 18.5264 15.118 39.739 24.3772 +8043 6 36.8049 28.4285 22.9464 16.1639 5.31016 -1.79263 +8044 4 36.683 28.9472 23.7552 -13.3671 -7.69746 -0.238436 +8045 4 36.1639 27.7179 22.9267 -11.0056 -9.60672 10.1241 +8046 6 21.894 30.586 27.4834 -30.837 -7.47848 12.2714 +8047 4 22.1658 31.0121 28.3029 9.93408 7.2142 -4.82479 +8048 4 22.5499 30.6966 26.8178 23.3081 1.01511 -13.2982 +8049 6 10.2866 3.2829 27.2371 9.19947 -3.548 -7.92128 +8050 4 10.1566 2.73648 28.0281 -11.5907 7.20828 -5.58516 +8051 4 9.50383 3.79492 26.9844 -8.05462 -4.00143 11.7964 +8052 6 37.7145 25.01 29.7057 15.6828 -51.4836 -24.4954 +8053 4 38.34 24.5625 29.0621 -16.831 21.3675 19.2093 +8054 4 37.2613 24.2159 30.07 -2.41186 22.6264 5.87672 +8055 6 9.13271 24.4444 14.4751 26.0421 8.18538 46.692 +8056 4 9.10912 24.9781 13.7161 -5.31341 21.9098 -32.4591 +8057 4 8.68548 23.6494 14.2981 -19.3974 -37.2941 -14.6224 +8058 6 52.771 31.4727 7.38558 20.6973 -2.13415 1.08713 +8059 4 52.3061 32.183 6.93204 -2.34942 2.78723 -4.55897 +8060 4 52.1263 30.9997 7.89938 -16.8139 -9.70652 3.3966 +8061 6 21.3286 5.45224 36.4983 22.333 -40.4406 3.83692 +8062 4 20.7026 5.40277 37.2139 -7.55906 11.9598 8.05023 +8063 4 21.8475 4.61683 36.6516 -9.65069 29.8227 -15.0031 +8064 6 25.1743 37.2092 4.31919 7.23092 6.80805 -6.24923 +8065 4 25.4754 36.7175 3.5165 -8.68629 0.834167 19.7743 +8066 4 24.8491 36.6197 5.01948 2.53349 -5.19005 -7.77823 +8067 6 34.0165 17.4759 18.2358 -58.4306 -31.0723 45.6386 +8068 4 34.1944 16.9598 19.0779 8.50138 15.1756 -22.5601 +8069 4 33.0528 17.7413 18.4058 39.5305 3.9888 -12.396 +8070 6 37.9578 37.5059 25.2944 -35.6234 -15.4362 -10.7836 +8071 4 36.9622 37.6721 25.197 38.0574 -5.35834 -1.14338 +8072 4 38.1643 36.7565 24.689 -7.79603 13.8086 8.25116 +8073 6 5.07735 4.86484 15.8417 42.9381 3.72816 7.10952 +8074 4 5.88838 4.293 15.9163 -33.8081 0.492332 -6.16483 +8075 4 5.50277 5.71956 15.9997 -16.006 -0.473971 1.61617 +8076 6 14.1507 7.19336 7.76886 38.052 -10.4208 -22.4486 +8077 4 13.5129 7.55624 8.34295 -29.9694 15.266 25.1048 +8078 4 13.7195 6.96448 6.9333 -0.98027 3.69224 9.82406 +8079 6 24.98 10.8641 38.0829 22.9212 14.7137 56.6455 +8080 4 25.3157 11.7906 38.09 -5.76353 -21.6486 -14.5596 +8081 4 24.5861 10.6473 37.2742 -21.4949 -6.61803 -48.2716 +8082 6 35.683 7.97762 22.8121 -8.7657 -2.24292 -6.28447 +8083 4 36.2591 8.71308 23.0369 7.49089 3.45465 4.10549 +8084 4 35.4159 8.13228 21.894 -1.16553 2.61323 2.89561 +8085 6 24.8067 29.1485 22.4175 -2.13284 -11.1741 5.39142 +8086 4 24.8847 28.3567 22.9764 5.78872 7.02228 0.265808 +8087 4 23.868 29.1687 22.2304 -8.38579 3.51829 -7.32943 +8088 6 38.496 31.6463 38.4547 5.18571 -7.52333 -11.192 +8089 4 38.5561 32.3892 37.8222 0.442926 -5.96945 11.3455 +8090 4 38.4779 31.9675 39.3579 -6.04594 15.0172 8.52038 +8091 6 7.23911 33.2316 15.4021 21.919 9.41665 12.382 +8092 4 8.12833 33.2899 15.8377 -30.0201 5.59214 -9.80336 +8093 4 7.41373 32.5516 14.7298 -12.8129 5.82399 11.4308 +8094 6 43.353 23.6104 1.44592 7.44142 11.305 12.851 +8095 4 43.1845 24.4377 0.974361 -3.6145 -11.1369 -5.61195 +8096 4 44.1543 23.8467 1.95013 -11.1925 -12.9992 -13.6036 +8097 6 3.53991 32.9016 14.8697 -2.39625 2.76445 6.29056 +8098 4 3.69073 33.2429 13.9877 -3.53656 0.018747 -12.9915 +8099 4 3.78624 33.6349 15.4383 2.83762 5.11564 5.16825 +8100 6 25.3096 21.77 8.26163 -6.66296 0.990367 -4.9072 +8101 4 26.025 21.1206 8.24337 -4.14835 5.1806 10.2199 +8102 4 24.7855 21.68 9.08833 13.2195 -2.77387 -11.0894 +8103 6 43.8224 15.3683 17.7688 -17.5044 -13.9077 -11.4765 +8104 4 43.5422 15.0425 16.8907 -4.65964 7.2866 4.53357 +8105 4 44.7684 15.2434 17.7192 12.2011 1.97977 1.51727 +8106 6 15.7838 16.2525 16.6573 54.0838 12.7989 52.3812 +8107 4 16.4697 16.8261 16.2793 -6.54184 -0.771336 -3.5329 +8108 4 15.1467 16.1661 16.0105 -48.6612 -2.23154 -48.9531 +8109 6 31.9022 12.8519 11.5241 2.75902 49.2592 5.12049 +8110 4 32.4395 13.2725 12.2474 -7.6131 -20.2803 -12.0836 +8111 4 31.5562 13.6461 11.0457 0.0384164 -26.7823 6.27126 +8112 6 18.2248 5.33623 10.1812 -15.488 18.8418 -23.6702 +8113 4 17.7687 5.75894 9.42369 15.7694 -11.8332 4.62439 +8114 4 17.5271 5.29555 10.8288 -1.36455 -9.23689 12.3446 +8115 6 23.0917 39.0779 10.9282 -11.4905 7.21092 -0.352408 +8116 4 23.963 38.6888 10.8472 1.7552 7.95734 1.65941 +8117 4 23.1114 39.9529 10.5005 0.666922 -10.0515 1.633 +8118 6 46.8677 33.7562 8.76248 1.03354 -2.05441 8.38343 +8119 4 46.5037 34.5328 8.27588 2.5022 -8.853 20.9954 +8120 4 47.1475 33.9422 9.6931 -6.44786 13.1686 -22.3696 +8121 6 31.243 39.9317 20.2224 2.33635 -7.70313 -8.05101 +8122 4 30.8704 39.2996 19.5871 0.699046 7.37293 6.91414 +8123 4 32.2017 39.8574 20.0757 -3.27099 6.09826 0.0696837 +8124 6 15.889 33.0919 19.7864 33.8788 -7.40125 -13.3883 +8125 4 16.1628 33.8221 19.1895 -10.4151 -15.5823 0.760964 +8126 4 16.5176 32.3427 19.5839 -16.9866 18.4919 10.6578 +8127 6 32.5555 39.9164 2.66523 30.0039 -10.6491 -2.95451 +8128 4 33.3508 39.5896 3.12591 -10.8726 3.49711 -8.16538 +8129 4 32.1027 40.3655 3.36837 -16.5932 8.39248 6.84073 +8130 6 50.6959 12.1983 3.90519 17.0412 -18.9771 -24.2847 +8131 4 51.4658 12.4814 3.40053 -2.43524 -2.94964 -4.56419 +8132 4 50.632 12.8314 4.58319 -9.04718 30.5099 32.8795 +8133 6 44.7022 2.76366 12.1205 -8.84849 12.6495 8.41904 +8134 4 44.8494 1.8734 11.8267 15.0216 -15.1797 -4.64519 +8135 4 44.7278 2.73137 13.1008 3.87902 2.35132 -20.2006 +8136 6 11.5141 11.9335 31.6448 -3.41939 3.48047 19.9552 +8137 4 11.2577 12.7405 32.1375 2.53248 -5.05318 0.0588515 +8138 4 11.4496 11.2091 32.2982 6.40928 8.91696 -7.15415 +8139 6 4.75269 10.0418 10.4949 -1.19321 15.9867 3.21309 +8140 4 5.0001 10.2283 11.4058 3.15466 -0.54389 -0.234941 +8141 4 4.46559 10.9018 10.1184 3.18705 -14.0527 1.96128 +8142 6 17.0994 25.0099 20.58 37.5195 36.994 -31.4742 +8143 4 16.2483 24.8536 20.9144 -42.3557 -15.7488 8.6923 +8144 4 16.9647 25.6792 19.8535 4.26961 -24.361 15.5384 +8145 6 48.1092 4.75471 14.8037 19.9531 12.9172 -19.4869 +8146 4 47.21 5.0173 14.8371 -33.3483 -4.43172 15.4156 +8147 4 48.388 5.38041 14.11 12.4129 -13.382 8.75366 +8148 6 18.8523 3.11742 3.41631 -21.2483 -3.07087 -4.7476 +8149 4 18.4665 2.24821 3.59937 1.50537 0.955968 2.27262 +8150 4 19.7704 2.98892 3.60058 26.8928 -3.50499 2.30699 +8151 6 35.4247 26.4577 29.0527 -22.8013 -8.66021 5.68805 +8152 4 35.5248 27.2067 28.475 -2.85698 13.778 -9.76065 +8153 4 36.2768 26.0489 29.0602 21.3259 -10.4415 3.203 +8154 6 32.3896 31.2185 12.8503 57.1958 12.7231 -6.23232 +8155 4 31.5925 31.2509 13.3022 -48.7441 2.01486 27.8379 +8156 4 32.2029 30.8426 12.0127 -5.8383 -14.614 -31.3947 +8157 6 33.0076 28.3366 37.5983 -27.3824 -5.67666 30.0102 +8158 4 32.1052 27.9852 37.8568 28.4022 2.55731 -9.07316 +8159 4 33.3988 28.5694 38.4733 -3.969 -4.9759 -22.0899 +8160 6 45.5072 24.7908 10.3169 -45.8214 60.3209 -7.47747 +8161 4 44.9002 25.317 9.70444 28.5781 -13.9385 29.3176 +8162 4 45.5876 23.9971 9.85482 14.9117 -49.3191 -19.3714 +8163 6 14.779 31.7044 3.16918 -45.5594 -6.97168 29.5477 +8164 4 14.0337 32.2859 2.90387 21.9125 -3.3602 -3.07131 +8165 4 14.4311 31.26 3.996 20.2164 14.1486 -26.6391 +8166 6 31.9242 7.68885 4.30286 23.54 -20.9123 31.4536 +8167 4 31.4705 6.84633 4.17995 2.0164 -2.82895 4.59018 +8168 4 31.5931 8.24323 3.64247 -18.259 33.7262 -37.7068 +8169 6 42.5699 17.3136 32.1968 24.1944 7.3606 3.32713 +8170 4 41.6254 17.2329 32.2603 -19.9776 4.79877 -7.53323 +8171 4 42.7917 18.2007 31.8224 -10.4585 -19.5065 0.0265862 +8172 6 13.8071 23.1746 23.5515 16.4347 -15.6283 -2.15259 +8173 4 13.5183 23.7639 24.245 0.233797 9.11225 10.6616 +8174 4 14.6093 22.7029 23.9066 -20.7684 16.5326 -5.05411 +8175 6 10.7126 7.09833 3.97095 14.1471 -33.6721 -68.9477 +8176 4 10.4245 6.93934 4.82914 -14.4566 -0.97954 55.1879 +8177 4 10.4869 6.2311 3.50145 10.3151 35.4271 10.8748 +8178 6 28.7967 8.6797 17.9015 -30.1103 -2.72244 -33.0478 +8179 4 29.5795 8.35746 17.4579 9.90558 -6.78874 -8.85398 +8180 4 28.1705 8.90161 17.1378 19.1156 -3.64084 26.8114 +8181 6 19.4515 29.3423 26.6295 -39.4767 12.5835 42.7579 +8182 4 19.0038 29.6555 27.482 17.5864 -10.0531 -35.2193 +8183 4 20.2946 29.7741 26.6551 17.8114 4.03003 1.9258 +8184 6 40.6571 40.9865 14.5722 30.7749 0.116883 17.4953 +8185 4 40.9453 41.7159 14.038 -4.90719 13.3855 -18.4876 +8186 4 41.4974 40.7167 14.9881 -11.2006 -4.47055 2.16552 +8187 6 46.2595 14.0857 31.7293 11.6035 -9.35965 4.24636 +8188 4 46.4659 13.1386 31.6985 -1.25294 5.8657 1.71226 +8189 4 45.5092 14.1916 31.1613 -13.5258 4.10617 -10.238 +8190 6 36.7111 36.3198 8.38634 20.5175 24.5507 44.7988 +8191 4 36.5848 37.248 8.66174 -25.6048 -20.3538 -28.8485 +8192 4 37.4262 36.1922 9.03978 -4.76011 -28.7723 -18.9481 +8193 6 30.7791 32.4382 38.0814 8.60258 1.74334 21.9396 +8194 4 31.3949 31.9394 37.5795 9.21482 -20.9838 -26.5205 +8195 4 31.4122 32.9586 38.5821 -11.3785 16.1645 3.6603 +8196 6 47.8794 8.8384 10.1746 26.299 41.1069 27.7005 +8197 4 47.2075 9.11907 9.56312 -13.0744 -2.84885 -16.672 +8198 4 48.1152 7.93695 10.1106 -1.40956 -33.8723 -12.987 +8199 6 24.4191 17.0005 30.9872 -11.3759 2.04439 -13.9008 +8200 4 23.6647 16.9339 30.3566 16.9629 0.0568796 9.7226 +8201 4 24.0218 17.1528 31.8579 2.94571 -1.21426 -7.57694 +8202 6 40.5018 5.09847 4.47991 -26.6992 -20.3188 -5.14046 +8203 4 41.28 5.65048 4.47318 14.3705 11.228 -11.5737 +8204 4 40.0798 5.05838 3.58104 19.0568 4.03597 15.916 +8205 6 52.5742 28.0973 6.9077 -25.4379 -29.0344 16.6943 +8206 4 52.3933 28.6001 6.11132 1.2128 1.19853 -1.81518 +8207 4 51.7383 27.5823 7.10916 28.4347 22.908 -9.38917 +8208 6 36.064 32.3866 23.6124 7.53581 -25.1682 -6.10704 +8209 4 36.4508 32.2046 22.7426 1.48893 5.77393 9.47334 +8210 4 35.7934 33.2936 23.5958 -9.41601 17.7382 0.925908 +8211 6 23.6488 31.8764 22.7665 2.85736 4.06253 -9.33391 +8212 4 23.7634 32.5358 22.0878 -9.04528 15.3932 -0.43099 +8213 4 24.3599 31.3007 22.5126 8.23075 -21.5035 13.0322 +8214 6 0.735457 24.4657 41.7131 -9.37188 -1.3071 -20.2528 +8215 4 1.20497 24.8068 40.9273 -3.735 -3.01915 11.177 +8216 4 54.8235 24.2347 41.4089 15.688 5.53844 3.35783 +8217 6 15.9771 8.98022 19.8191 22.6241 -28.8974 20.594 +8218 4 15.5109 8.26292 19.4118 -7.13343 -10.7615 -13.7959 +8219 4 15.6388 9.77471 19.4696 -19.2292 39.8019 -15.8774 +8220 6 33.1716 12.5629 20.0326 13.9441 -12.6476 -4.49459 +8221 4 32.9044 11.6183 19.8429 16.5289 30.3248 6.35834 +8222 4 34.162 12.7185 19.975 -34.5589 -12.2038 -12.3621 +8223 6 7.03971 24.945 26.3683 -0.33354 -9.69316 23.9049 +8224 4 6.80945 24.3756 27.1101 -9.22275 -9.46444 -2.85995 +8225 4 7.84656 25.3251 26.6963 17.391 9.90995 -3.06061 +8226 6 44.4739 22.5508 36.9255 -16.7075 -6.88118 10.4755 +8227 4 43.5027 22.4108 36.9334 15.1456 1.07948 9.67769 +8228 4 44.6732 22.7799 36.0336 3.04889 5.98288 -21.3947 +8229 6 39.2775 23.7142 25.1185 -44.4168 -97.0378 5.9092 +8230 4 39.6033 24.5307 24.937 33.9242 88.3913 -14.6991 +8231 4 38.7559 23.4597 24.3323 8.03463 3.9453 13.1815 +8232 6 20.3756 2.20712 36.9897 -7.56257 -5.27652 1.95266 +8233 4 20.2168 1.45659 37.5665 4.06747 -3.41627 8.94019 +8234 4 20.2802 1.85339 36.1124 5.28277 1.38 -10.8685 +8235 6 22.8571 19.5527 3.6659 6.2145 7.79245 45.4341 +8236 4 22.8782 19.7834 4.64919 -10.5004 -5.13291 -37.3231 +8237 4 23.7426 19.8021 3.38476 9.02488 -3.84737 -6.15569 +8238 6 31.6989 12.5719 34.5929 20.3571 12.3337 69.8717 +8239 4 31.0774 13.2339 35.0297 17.9304 -15.3013 -22.977 +8240 4 32.3378 12.3324 35.3667 -30.4994 7.85147 -45.3393 +8241 6 12.9846 10.2214 25.1019 -30.6317 10.0697 -32.3453 +8242 4 13.6677 9.95937 25.6652 38.8731 -4.05338 37.0168 +8243 4 12.5116 9.4018 25.0264 -11.673 -9.01961 -8.06086 +8244 6 27.2702 0.587979 13.2088 -29.2359 -8.68669 8.17042 +8245 4 27.7024 41.6312 13.2942 -2.56798 3.03598 -7.56301 +8246 4 26.2795 0.464606 13.259 26.6373 -0.778522 -5.81594 +8247 6 5.6575 24.9337 13.9905 13.1991 2.90197 -9.87868 +8248 4 4.70598 24.9553 13.883 -5.9976 0.782062 8.57209 +8249 4 5.90972 25.4072 14.7914 -9.20077 -1.59682 1.38283 +8250 6 22.9799 17.9518 0.527007 -12.0607 -30.0717 13.8125 +8251 4 22.428 18.6392 0.176667 -3.67819 14.6501 -9.17369 +8252 4 22.2816 17.3415 0.914453 31.709 16.1034 -10.9012 +8253 6 33.0985 25.4181 5.46205 -15.7978 -31.0624 1.20161 +8254 4 33.3789 26.3039 5.55078 15.9502 30.9866 -6.27287 +8255 4 32.9645 25.2082 4.52957 3.04969 3.7853 3.27689 +8256 6 8.52872 7.94688 17.4833 18.4257 15.9711 -24.7978 +8257 4 9.39098 8.3855 17.3119 -11.8135 -8.35054 -2.98105 +8258 4 8.4858 7.94817 18.4262 -6.55829 -2.0729 23.5191 +8259 6 26.8237 0.686378 2.88748 4.07 30.2002 2.01549 +8260 4 26.8412 0.391628 3.80568 -3.86709 0.733005 8.35451 +8261 4 26.5975 1.66265 2.91719 8.86873 -29.5911 -1.41132 +8262 6 50.0397 34.7157 15.6267 -11.8175 -1.09292 -1.87233 +8263 4 50.6372 35.2521 15.0721 -14.1207 -5.91477 -4.02646 +8264 4 49.1323 34.6374 15.219 24.748 6.82197 2.94942 +8265 6 46.275 5.00035 11.1282 9.7079 18.7279 -10.06 +8266 4 45.8191 4.20733 11.3912 -11.1099 -14.8598 8.88229 +8267 4 46.9633 4.71614 10.5231 1.70636 -6.51939 -1.67277 +8268 6 33.7833 38.63 35.3851 22.6491 -26.5736 53.3982 +8269 4 34.0604 38.9625 36.3013 -14.2885 -2.00103 -44.5517 +8270 4 33.6201 39.3455 34.786 -2.63152 22.0909 -4.2817 +8271 6 30.8201 25.8435 41.2101 0.522631 -30.718 -12.9218 +8272 4 31.0968 24.9266 41.4082 -1.05643 6.85883 -6.1679 +8273 4 31.1715 26.3436 0.016995 6.66556 20.3816 22.2796 +8274 6 50.2276 0.978128 24.4598 74.6558 22.0158 36.8282 +8275 4 49.5306 0.534407 24.0585 -38.5843 -30.8873 -31.929 +8276 4 51.1134 0.532188 24.3239 -37.6779 9.32343 -0.630533 +8277 6 31.2996 0.720873 19.0302 14.3507 40.5737 -10.6901 +8278 4 30.4605 0.743437 18.5837 -16.9464 -9.10756 -3.3833 +8279 4 31.3343 41.8987 19.5933 -6.31648 -47.867 22.0648 +8280 6 39.0778 29.5479 19.1423 -24.9794 -6.4558 -1.7207 +8281 4 38.1293 29.5816 19.4551 33.1986 -8.08964 -3.40762 +8282 4 39.446 28.6506 19.2986 -6.02354 14.8003 0.990496 +8283 6 21.659 17.5991 25.8953 -11.5386 33.2832 -7.33353 +8284 4 22.0418 18.5204 25.967 -8.02723 -30.5851 6.12101 +8285 4 20.778 17.7492 25.4824 18.7799 -9.30112 4.66445 +8286 6 35.0777 28.803 27.4254 -1.70316 -21.0069 37.4458 +8287 4 35.3301 29.4791 28.0775 3.3924 -2.39002 -8.5847 +8288 4 35.0935 29.2141 26.5843 6.79083 21.8236 -32.9604 +8289 6 30.7137 25.4449 11.6588 -11.4017 25.922 39.321 +8290 4 30.5753 25.9017 12.5616 8.60864 -26.5127 -36.0552 +8291 4 30.5331 26.1452 11.022 4.69716 -0.666916 0.479504 +8292 6 7.33812 15.1344 12.3538 4.68116 -40.544 31.6975 +8293 4 6.75693 14.3594 12.209 2.06777 16.361 -3.14284 +8294 4 7.31295 15.622 11.5607 -9.0052 27.071 -31.8075 +8295 6 16.8334 26.8188 7.04972 -25.5936 3.66279 -30.8653 +8296 4 17.5758 26.708 7.59816 38.4339 -11.2263 23.8467 +8297 4 17.1819 26.9966 6.1597 -5.58153 -2.73835 6.66814 +8298 6 29.5302 33.0784 31.0001 -37.3865 -15.0005 -19.6245 +8299 4 28.6433 32.7554 30.7459 2.04647 15.9344 -4.27919 +8300 4 29.8764 32.2746 31.3613 18.5632 -10.7791 20.7082 +8301 6 14.1048 2.11879 30.9099 -3.69766 -14.7615 43.6071 +8302 4 14.1458 1.95878 31.9138 -8.46722 9.63961 -39.7078 +8303 4 13.6642 1.31591 30.5661 9.09938 8.95306 -0.112961 +8304 6 15.6571 22.2632 2.89617 -37.5764 43.5932 -9.62192 +8305 4 16.4348 21.7941 3.05118 39.5293 -34.0009 4.7875 +8306 4 15.0286 21.6897 2.4522 -3.10464 -12.538 6.06705 +8307 6 23.7259 29.1153 40.9645 17.3396 38.8389 1.6287 +8308 4 23.2818 30.0193 40.9831 11.4767 -32.1544 -0.906545 +8309 4 24.7087 29.2887 40.9216 -25.4222 -7.32646 2.20707 +8310 6 38.1247 14.1642 13.7107 12.8592 31.0763 6.54808 +8311 4 37.6278 13.3808 13.8383 -17.8092 -31.0521 2.1891 +8312 4 38.9029 13.9224 13.2095 7.41852 -3.42228 -8.90759 +8313 6 35.2503 26.5068 15.521 -3.09354 13.3371 19.8917 +8314 4 34.5349 26.5126 14.8818 -0.932758 -4.81772 -4.34805 +8315 4 34.9075 27.0382 16.2823 10.0491 -13.0104 -19.4153 +8316 6 19.0968 34.7379 16.486 5.71756 23.995 22.7437 +8317 4 19.4075 35.6523 16.3704 4.72819 -11.1284 17.3551 +8318 4 19.0401 34.4508 15.6072 -6.41662 -20.6903 -39.0731 +8319 6 18.1723 29.7514 35.7083 20.6671 12.6318 -10.71 +8320 4 18.3041 30.5743 35.1773 -7.60682 -14.8418 20.474 +8321 4 19.0351 29.5718 36.145 -10.3356 2.9076 -6.19235 +8322 6 54.1213 22.2675 24.9131 12.7342 -33.1199 -26.8219 +8323 4 53.6265 21.7967 24.1967 9.15099 10.4438 12.7736 +8324 4 53.5183 22.8995 25.2476 -23.1208 24.5105 7.38222 +8325 6 30.3446 10.3415 34.0026 7.84994 -0.761596 -9.91104 +8326 4 29.5868 10.4349 34.5739 -14.9697 1.07498 11.7851 +8327 4 30.8511 11.1643 34.0933 -4.52293 -3.62201 3.70872 +8328 6 38.3178 33.8965 18.5989 -35.8058 -11.4104 -3.76591 +8329 4 38.923 33.166 18.7063 19.7544 -4.29321 9.06839 +8330 4 38.8137 34.6503 18.3352 23.7539 21.4454 3.52643 +8331 6 22.4873 14.1653 34.4312 -21.9658 -17.0918 -49.1801 +8332 4 22.5571 13.4626 33.7145 -4.81718 29.7264 22.473 +8333 4 23.0772 13.8965 35.1058 26.7449 -1.29975 22.8703 +8334 6 38.021 0.617904 2.36461 -2.26574 -7.91048 -40.4777 +8335 4 37.6239 1.19646 3.0125 3.99393 1.59858 23.4614 +8336 4 38.7851 0.132723 2.71367 -6.22024 4.30596 13.4956 +8337 6 38.885 41.133 10.292 38.4397 69.693 -20.9517 +8338 4 38.7327 0.223589 10.3334 0.502898 -40.1285 -2.38265 +8339 4 38.1678 40.7662 10.7395 -40.074 -22.1176 34.0334 +8340 6 53.417 21.9266 38.962 18.4876 1.53578 17.2983 +8341 4 52.9974 21.8755 38.1026 3.71535 5.74942 -10.4205 +8342 4 54.37 22.1639 38.7939 -25.8904 -11.793 -3.59034 +8343 6 39.9933 12.7125 36.2959 -18.8272 27.1562 12.2819 +8344 4 39.0734 12.4542 36.2547 -7.90274 -1.75871 9.35878 +8345 4 40.3901 12.0873 35.7283 26.8007 -18.4843 -23.2317 +8346 6 48.44 17.2431 40.5981 -19.9836 6.93831 4.04917 +8347 4 47.6199 17.7956 40.4399 22.5854 -23.5642 7.97707 +8348 4 48.3147 16.8142 41.4747 5.07747 10.2388 -9.33604 +8349 6 32.0284 9.3439 40.0151 10.5149 -12.1651 13.6504 +8350 4 32.8546 9.41316 39.523 -1.99935 -3.17675 -6.39298 +8351 4 31.9706 8.39334 40.2816 -10.0936 21.7982 -4.27543 +8352 6 31.75 22.4929 6.3685 -34.2181 3.54143 23.53 +8353 4 31.3779 21.709 6.82557 12.2201 6.35834 -11.7559 +8354 4 31.3059 23.2194 6.8777 16.0591 -13.7554 -15.3432 +8355 6 51.0144 2.58529 21.579 28.4772 -3.64411 10.4611 +8356 4 51.4343 1.72703 21.8198 -11.0001 9.38403 -4.71992 +8357 4 51.7571 3.20177 21.4507 -11.3685 -6.83795 2.38662 +8358 6 13.6247 22.0465 12.1442 29.0901 0.46256 9.76546 +8359 4 14.4578 22.3795 12.5465 -13.9989 1.27328 -8.95219 +8360 4 12.915 22.6494 12.3833 -3.04453 8.5056 -1.94564 +8361 6 23.6209 24.0381 14.6453 -17.5202 11.834 -36.5316 +8362 4 24.2009 24.4886 15.2598 9.8869 4.60732 -3.70937 +8363 4 23.5497 24.6116 13.8304 3.00595 -20.2815 30.972 +8364 6 9.32136 4.85156 31.2387 8.97842 0.466865 -3.67014 +8365 4 8.41764 4.8259 30.9291 -8.7496 -0.132795 -7.84821 +8366 4 9.23666 5.38964 32.029 2.44443 -3.9247 9.21777 +8367 6 16.6769 26.3146 18.0426 -28.7898 -24.0576 -1.25383 +8368 4 15.7763 26.5978 17.7405 22.2361 3.17889 2.46191 +8369 4 17.2688 27.0532 17.9767 7.52301 23.5471 -7.71583 +8370 6 5.12002 13.5179 11.5454 -28.2867 15.553 -42.5279 +8371 4 4.34318 13.4159 12.0982 -3.89331 -5.54815 13.62 +8372 4 4.69334 13.8537 10.6805 23.3071 -7.58808 40.5266 +8373 6 29.613 23.6535 8.07622 4.06305 -5.39054 -18.0309 +8374 4 29.2087 23.3655 8.89798 -2.48969 6.78204 1.65997 +8375 4 29.356 24.5861 7.97247 8.33853 -10.6544 5.22118 +8376 6 0.809058 7.56442 27.8431 6.90575 4.16885 -14.0934 +8377 4 0.916059 7.33161 28.7668 -1.2645 -7.40385 9.39857 +8378 4 1.47033 8.27499 27.7095 -9.19662 -21.8408 -1.77541 +8379 6 15.4183 9.78145 0.490529 10.0725 -7.13925 0.979932 +8380 4 16.087 9.43012 41.8027 -0.259761 -4.12548 -6.98761 +8381 4 15.4693 9.20893 1.26423 -1.27146 5.63374 6.96511 +8382 6 18.8191 0.059487 34.1187 -25.6574 -0.396319 -31.4644 +8383 4 18.4098 41.5755 33.3103 16.2128 4.97009 18.3796 +8384 4 18.5054 0.975155 34.0945 0.533414 5.37151 1.64989 +8385 6 18.7349 30.7803 29.1665 47.4813 -67.7405 25.7886 +8386 4 19.5534 30.6866 29.7899 -42.3671 12.2249 -32.0712 +8387 4 18.5184 31.6699 29.0545 -8.91834 48.7901 3.3651 +8388 6 48.4474 16.4903 36.136 -4.39653 9.55775 -4.4164 +8389 4 47.5651 16.9082 36.2181 15.0357 -0.381514 0.207393 +8390 4 48.471 16.1274 35.2331 3.08724 1.10756 7.15907 +8391 6 43.7979 0.472205 29.2706 42.555 -4.96452 -15.1149 +8392 4 42.8863 0.267919 29.38 -32.9664 -6.64218 10.9475 +8393 4 44.2792 41.5357 29.3524 -8.26894 11.2804 8.78801 +8394 6 16.7205 13.887 21.3769 2.19577 2.66609 -2.49996 +8395 4 16.2052 14.7022 21.5336 6.85381 -11.1318 0.719729 +8396 4 16.6911 13.4037 22.2072 -6.06459 1.50462 5.19021 +8397 6 17.3883 13.4356 26.2524 27.4966 3.2637 -26.6685 +8398 4 18.1303 13.5822 25.5825 -26.8694 -2.13737 32.6247 +8399 4 17.6394 12.6216 26.7148 -3.51452 -0.718268 0.201186 +8400 6 48.1557 10.2329 23.6958 7.66187 -11.6345 21.9365 +8401 4 48.0869 10.5828 24.5972 -4.20109 -8.3855 -4.21906 +8402 4 47.9242 10.9774 23.1563 3.12678 5.33996 -12.4543 +8403 6 28.2651 17.9126 17.8865 15.704 23.8601 -19.8805 +8404 4 29.0328 18.4581 17.6288 -8.16305 -6.08358 1.86534 +8405 4 28.6272 17.0995 18.2183 0.672722 -20.799 10.0784 +8406 6 54.0866 38.1772 23.6885 15.2416 -7.03948 -9.32302 +8407 4 0.015845 37.9236 23.4759 -13.1891 10.5947 7.1207 +8408 4 53.5403 37.6177 23.1226 -4.14834 -2.69562 5.50015 +8409 6 8.47885 18.3973 11.4073 -18.4373 -13.8141 42.9629 +8410 4 7.63335 18.6519 11.0416 -6.40415 6.02722 -6.48684 +8411 4 9.12927 18.583 10.7796 32.3175 8.52747 -41.6205 +8412 6 45.9451 12.8796 11.0371 -17.0736 -2.86831 -37.3051 +8413 4 46.6905 12.613 10.4807 4.61659 2.073 6.35499 +8414 4 45.2044 12.775 10.3831 8.06265 2.44535 24.075 +8415 6 16.2127 8.79404 14.0297 41.7324 -66.6139 22.361 +8416 4 15.4739 9.28873 13.8367 -45.7772 50.9633 -18.0772 +8417 4 17.0286 9.27652 14.012 9.93977 26.888 -8.08533 +8418 6 42.7214 13.3612 21.3881 16.6788 44.7105 -2.77317 +8419 4 41.8036 13.1589 21.3301 -20.1042 -28.5105 -1.62877 +8420 4 42.6833 14.2978 21.1276 5.52546 -8.26362 1.62797 +8421 6 21.0018 40.4256 16.4674 21.2457 -19.0828 1.73859 +8422 4 20.7372 40.049 17.3276 2.67731 3.65462 -7.46566 +8423 4 21.8606 39.9985 16.1939 -29.0987 10.293 9.55187 +8424 6 45.6337 11.4313 32.9356 51.1157 -40.0447 2.01383 +8425 4 46.3303 10.7696 33.2563 -29.172 28.0234 -20.2541 +8426 4 45.1866 11.676 33.7277 -20.3741 9.53259 21.5498 +8427 6 26.9484 8.87146 24.2965 48.4346 1.85391 18.4292 +8428 4 27.5311 9.68141 24.3337 -29.9021 -15.2605 -8.39328 +8429 4 27.4823 8.26118 24.8676 -16.4416 6.67878 -12.0087 +8430 6 18.977 2.43413 29.3663 0.758316 16.52 -7.40381 +8431 4 18.1944 2.4248 29.9271 -0.767207 -2.12047 7.99903 +8432 4 19.1173 3.36872 29.101 -3.03797 -9.07666 7.57415 +8433 6 8.2454 29.1679 19.723 -8.63488 -12.9151 21.1286 +8434 4 8.14448 28.8871 20.6627 3.14293 7.67545 -21.2948 +8435 4 7.83715 28.464 19.1969 -1.03495 3.62674 2.54809 +8436 6 9.03976 34.3129 18.6533 -7.54593 -6.72093 -3.09965 +8437 4 8.77081 34.2931 19.577 -0.177883 2.97642 -7.59668 +8438 4 9.06659 35.2455 18.4187 6.50563 1.62734 -4.46359 +8439 6 10.1892 11.9266 11.2355 -21.5107 11.0325 -1.739 +8440 4 10.2333 12.874 11.065 17.4692 -2.43612 -1.88546 +8441 4 9.23632 11.7983 11.121 5.09535 -6.80078 4.24402 +8442 6 35.7546 21.6858 36.1669 -23.2352 21.9394 0.834429 +8443 4 35.0265 22.3595 36.1433 18.2091 -18.4066 2.26802 +8444 4 36.3924 22.0173 36.8321 -9.99636 -6.87572 -9.75527 +8445 6 17.0812 12.5048 36.3903 -12.1142 25.6516 12.5185 +8446 4 17.3175 12.8308 37.2812 -0.49448 -9.18651 -10.1264 +8447 4 17.5662 11.7075 36.2155 7.76979 -20.5663 -1.07791 +8448 6 37.1566 13.0227 34.2843 -17.9764 -6.1284 -55.2853 +8449 4 36.5549 12.2662 34.3472 4.68366 1.60167 -17.3784 +8450 4 37.3932 13.1268 35.1567 14.9075 13.7384 64.605 +8451 6 38.9862 29.5501 13.2301 -1.89389 21.6683 -7.70005 +8452 4 38.7944 28.7085 12.8419 -2.19861 -17.9948 -10.7911 +8453 4 38.6501 29.4932 14.1174 1.27468 3.77518 16.782 +8454 6 0.176516 29.3495 29.4845 -12.5141 10.2637 -5.31555 +8455 4 0.737394 28.6151 29.2028 3.82179 3.49987 -8.15609 +8456 4 54.9814 29.9211 28.6995 5.57042 -17.7863 13.6106 +8457 6 15.9458 0.256833 12.7596 -44.0073 4.56069 2.48191 +8458 4 15.316 0.578271 12.0799 19.6091 -0.692249 -3.06606 +8459 4 15.3039 41.7798 13.3939 19.5978 -0.7471 3.56907 +8460 6 3.99127 11.9482 8.78851 -15.4327 -39.7622 32.4444 +8461 4 4.35413 11.6179 7.97869 6.27746 3.41828 -23.4587 +8462 4 3.98972 12.8788 8.75552 1.02746 43.1268 -6.73396 +8463 6 24.041 23.6822 19.9783 33.1595 11.366 0.122861 +8464 4 23.6132 22.8866 19.7159 -20.0299 -17.1205 -2.84168 +8465 4 23.4218 24.2757 20.3917 -9.46777 4.2557 4.80954 +8466 6 4.48057 2.29323 23.9805 -22.9759 10.1361 69.4322 +8467 4 4.73792 2.40802 23.1034 3.49419 10.2026 -52.1527 +8468 4 3.69711 2.85929 24.1902 11.7092 -10.5693 -13.4065 +8469 6 33.0966 27.663 33.8386 -28.073 -12.9468 -7.71443 +8470 4 33.3687 28.5694 33.7309 6.85765 13.8135 -2.76136 +8471 4 33.7449 27.1385 34.2981 13.436 1.78162 12.2729 +8472 6 11.3912 21.7129 6.08719 -17.5666 -2.19741 -2.39462 +8473 4 12.3323 21.6847 6.05692 28.5529 -3.65784 2.285 +8474 4 11.1694 22.1681 5.26899 -4.22105 -2.6604 -2.39966 +8475 6 37.2225 13.5364 23.6261 -18.6729 23.2035 4.88571 +8476 4 37.3138 14.0862 24.4412 -7.0733 -14.7121 -13.3014 +8477 4 37.9734 12.9786 23.5155 30.7338 -8.31921 -1.90296 +8478 6 5.00503 21.0366 33.3647 1.8453 38.5327 -33.3657 +8479 4 4.21257 21.4237 32.9267 15.1329 -13.9269 -2.57683 +8480 4 4.69097 20.5075 34.0602 -12.1996 -25.3348 31.8286 +8481 6 18.1998 37.5792 26.9379 10.6598 2.97497 -14.5277 +8482 4 17.7896 38.4267 27.1371 3.99806 -1.69574 -0.528064 +8483 4 18.8493 37.7746 26.2284 -6.0853 -8.42077 12.5802 +8484 6 19.7447 16.1537 4.6847 3.25094 -1.99961 -5.02271 +8485 4 18.927 15.8729 5.11398 3.02189 5.09699 3.93014 +8486 4 20.4865 15.8366 5.22215 -5.31395 3.35724 3.77112 +8487 6 54.074 32.5125 15.5854 10.3761 -37.3618 -30.9158 +8488 4 54.8842 32.2065 16.0104 -1.29748 4.29224 -6.87141 +8489 4 53.7047 33.0976 16.2003 -18.9781 34.1452 25.1436 +8490 6 31.1314 3.81684 36.7321 -0.834289 -2.49025 -7.10722 +8491 4 31.1103 4.02948 37.6722 -6.54843 -2.60835 4.18586 +8492 4 30.7135 2.95482 36.5673 3.74099 5.55874 7.56308 +8493 6 11.8386 14.3591 5.9475 31.6488 6.08621 47.6135 +8494 4 11.9235 13.4381 5.72501 -3.84758 -8.60837 -9.73648 +8495 4 12.4264 14.4198 6.78937 -30.0453 0.761866 -39.8937 +8496 6 30.4739 33.6971 6.46755 -23.3776 20.1936 16.0158 +8497 4 30.0841 33.0849 7.09297 -6.22519 -2.1618 10.9649 +8498 4 31.0937 33.1726 6.0102 25.8315 -23.5027 -25.5745 +8499 6 12.7945 0.536645 21.6661 -31.9857 18.4102 -14.2222 +8500 4 12.046 0.975194 21.1709 21.6431 -18.6961 6.09473 +8501 4 12.7507 0.998686 22.5059 13.427 -0.157027 11.5383 +8502 6 52.7685 7.22113 26.1957 6.97037 27.5507 21.845 +8503 4 53.4259 7.92282 26.4698 -21.5773 -21.2317 -16.9414 +8504 4 53.0823 6.78628 25.4103 4.46247 -3.68205 -10.7225 +8505 6 39.7279 40.8849 3.7445 22.9677 17.8938 -40.8272 +8506 4 39.3244 40.0392 3.76563 -12.6427 -25.5287 10.0743 +8507 4 39.6614 41.3038 4.58361 -3.65945 6.85452 27.763 +8508 6 20.1085 31.9188 21.9984 -7.05206 -5.67602 7.13377 +8509 4 19.4287 32.0842 22.6964 14.9272 -8.91322 -13.6161 +8510 4 20.3617 32.7769 21.6609 2.64243 15.0084 0.0829653 +8511 6 12.8674 35.0052 4.44359 43.5281 -46.0898 9.1613 +8512 4 12.2643 35.7062 4.40975 -34.4326 42.8527 -2.74399 +8513 4 13.784 35.3443 4.35073 -14.7319 6.47242 -4.65586 +8514 6 24.0589 33.6612 24.8588 9.55704 11.7193 -6.52578 +8515 4 23.7303 32.9012 24.3903 -5.13736 -12.3884 -10.0474 +8516 4 24.8786 33.8838 24.3903 -2.58553 -1.28908 -1.69824 +8517 6 40.1426 40.9082 22.7393 38.5538 -20.8809 37.5387 +8518 4 39.5402 41.0833 22.0513 -32.6743 7.60774 -19.3027 +8519 4 39.6696 40.5795 23.5226 -1.01773 2.4492 -9.99125 +8520 6 15.5532 2.81426 38.4448 -20.0738 34.0709 23.3703 +8521 4 14.8967 3.48174 38.7749 9.17215 -23.4566 -12.8824 +8522 4 16.1607 3.33672 37.9186 19.8661 -0.634992 -1.43825 +8523 6 41.016 9.18565 16.9561 17.4117 -10.7022 -18.9926 +8524 4 41.8597 8.69641 16.8054 -9.41989 12.8418 6.23764 +8525 4 40.6131 8.73354 17.6887 -9.17188 -2.41438 15.2761 +8526 6 43.1923 41.3931 9.58697 -22.3356 -19.1489 -3.62619 +8527 4 42.3612 40.9845 9.24256 14.3618 0.824315 8.65898 +8528 4 43.3433 0.185675 8.9708 1.58778 19.1204 -6.9238 +8529 6 24.903 37.9158 30.7914 -43.8554 -5.41491 21.3724 +8530 4 23.952 37.804 31.173 48.4757 4.96182 -14.1951 +8531 4 24.7905 38.4252 29.9913 -4.69729 3.46822 -12.8277 +8532 6 2.22055 5.32897 16.4318 -0.704957 11.5959 2.51569 +8533 4 1.8086 4.56809 16.8519 3.25773 -6.94195 4.1641 +8534 4 3.17492 5.17974 16.3235 -2.45649 -10.6256 -1.35481 +8535 6 1.39662 14.9371 19.1386 6.71081 10.2639 18.1623 +8536 4 0.558182 14.6006 18.8448 -10.0768 -10.7254 -15.2923 +8537 4 1.25744 14.8844 20.1022 8.06638 5.64899 -3.4629 +8538 6 34.3184 26.5435 23.7018 12.956 38.2174 -10.8067 +8539 4 33.6096 26.6326 23.0506 -6.28704 -5.42218 7.19498 +8540 4 34.253 25.729 24.1673 -8.0715 -30.4977 4.91012 +8541 6 41.932 21.8144 37.5476 -28.1346 24.458 10.6264 +8542 4 41.9653 21.2973 38.3662 8.82952 -0.726087 -9.88338 +8543 4 41.2985 22.5209 37.8344 14.7394 -10.5077 -10.9774 +8544 6 39.4289 37.6722 12.6363 -7.06663 36.6798 -8.56095 +8545 4 38.7214 38.0767 13.1674 9.12422 -13.2372 3.4836 +8546 4 39.8791 38.4903 12.2996 -0.376717 -30.7746 7.3995 +8547 6 30.2308 35.8744 2.88429 56.3256 -5.17531 19.584 +8548 4 29.7395 35.078 2.8871 -14.5394 -27.2578 -4.40621 +8549 4 29.6846 36.541 2.55195 -33.266 39.3858 -14.7027 +8550 6 50.3691 12.2996 11.0379 -10.7742 -32.245 -38.7061 +8551 4 50.5492 13.1381 11.4098 4.20277 26.7051 25.7379 +8552 4 50.0731 11.6929 11.7162 -2.05651 -3.66514 15.0978 +8553 6 38.4203 1.52686 34.6552 6.3891 -23.1477 32.9209 +8554 4 38.2942 1.9363 33.8354 -7.66336 30.6162 -40.7111 +8555 4 38.1079 0.632206 34.5078 -6.35148 -11.0336 -1.97829 +8556 6 23.4679 32.2557 29.2149 -43.4567 -12.6916 53.2324 +8557 4 24.0296 32.8423 28.7424 12.6247 17.2837 -9.6693 +8558 4 23.1232 32.6929 30.0761 24.9901 -11.6617 -44.232 +8559 6 36.561 38.8488 8.89417 42.7368 2.70764 46.8348 +8560 4 35.962 39.5202 8.64255 -29.9788 24.4889 -23.0747 +8561 4 36.8832 39.1244 9.78764 -11.193 -6.37855 -17.8717 +8562 6 35.882 15.8491 32.4345 4.38917 24.4094 -11.8898 +8563 4 36.1253 15.4284 33.2547 4.1797 -3.844 11.2859 +8564 4 36.4849 16.63 32.3181 -12.6028 -21.8682 2.29862 +8565 6 22.2747 21.8257 41.5848 1.63659 45.0851 -0.0273952 +8566 4 22.1351 22.8132 41.5538 -4.13496 -33.3395 13.1468 +8567 4 23.0832 21.7834 41.079 15.3069 -18.439 -3.51535 +8568 6 24.3693 38.6933 37.0124 5.99709 22.8296 -9.01594 +8569 4 25.2224 39.1901 37.0147 -13.2325 -18.2305 -0.0611307 +8570 4 24.4452 38.0141 37.6805 1.8393 -10.9749 7.25289 +8571 6 45.85 22.0674 16.0435 -6.35855 -11.009 -33.5755 +8572 4 46.1693 22.2375 15.1223 -5.70657 5.73574 25.2515 +8573 4 45.3177 21.2496 15.9445 13.424 8.98362 5.88408 +8574 6 34.0938 26.1451 39.6028 29.3502 -8.72422 32.5359 +8575 4 33.1775 26.2044 39.4639 -36.6108 3.5864 -15.8394 +8576 4 34.1454 26.1252 40.583 9.60862 3.8872 -14.9166 +8577 6 7.22316 36.161 23.2803 -75.9344 2.48999 -44.2827 +8578 4 7.2061 37.0658 22.9632 2.60813 8.07149 -4.69042 +8579 4 7.98979 36.1134 23.7455 79.8131 -8.28428 52.3852 +8580 6 29.1469 40.7664 9.14908 25.9603 -62.9641 -41.536 +8581 4 29.104 40.2522 8.28913 -11.1672 35.4313 19.904 +8582 4 29.7179 40.1086 9.59652 -3.22944 23.7461 21.8778 +8583 6 29.3725 11.2348 1.3024 -38.7794 14.8627 17.4065 +8584 4 28.4703 11.3821 0.891273 31.6728 -0.63192 16.6295 +8585 4 29.2803 11.4968 2.26097 5.36173 -12.1272 -32.3877 +8586 6 30.9813 3.70043 14.0775 0.393287 -12.1193 -7.6118 +8587 4 31.3533 2.81844 14.3971 -7.37725 32.1126 -17.4345 +8588 4 30.796 3.71521 13.098 8.52465 -17.2224 25.8707 +8589 6 29.7018 15.2871 38.2765 -11.7342 18.5436 -44.4423 +8590 4 30.2882 15.1814 38.9925 24.3773 -7.28175 32.8118 +8591 4 30.1059 15.9805 37.6877 -12.7379 -16.9908 17.8861 +8592 6 36.618 0.316233 29.1564 -1.13478 17.6011 -18.8673 +8593 4 37.4497 0.805382 29.2328 -0.537074 -5.31334 10.7084 +8594 4 36.0611 0.935156 28.6408 3.38103 -20.3125 11.7491 +8595 6 47.6566 0.117823 23.249 5.11875 5.73062 -10.5794 +8596 4 46.969 0.414744 23.8324 -12.4062 9.53281 16.9836 +8597 4 47.4018 41.1354 23.0496 0.315762 -17.3342 0.264415 +8598 6 7.91605 37.1729 29.9478 9.96828 38.7234 29.3851 +8599 4 7.8238 37.3188 30.9485 4.22886 -13.4646 -46.5453 +8600 4 8.48708 37.9472 29.6677 -24.8232 -29.7333 9.09982 +8601 6 38.925 24.2263 12.6374 28.6028 -18.1679 -25.4959 +8602 4 37.978 24.1747 12.7226 -16.6271 -1.4443 2.40459 +8603 4 39.1586 23.5255 11.9538 -9.24307 26.9603 22.464 +8604 6 21.3053 26.2545 36.7859 14.9917 45.9325 1.16 +8605 4 20.8074 25.7232 36.1994 -14.2562 -21.9874 -17.8757 +8606 4 21.6248 25.6951 37.4625 3.91421 -21.0802 23.8691 +8607 6 28.2258 23.3284 24.9888 19.6442 1.87868 9.60148 +8608 4 28.2493 24.0261 25.6588 -3.93467 -3.60043 -2.01642 +8609 4 29.1002 22.8932 25.0573 -18.3502 1.43704 -4.70914 +8610 6 38.4116 39.5691 14.5896 29.669 -4.24194 25.1928 +8611 4 38.4978 38.8692 15.3261 -6.52385 31.9806 -37.1925 +8612 4 39.2924 40.0897 14.6163 -46.5668 -30.9815 -6.21074 +8613 6 26.0432 5.99751 38.1148 44.5658 1.98351 30.7371 +8614 4 26.452 6.86444 38.1066 -12.5768 15.2327 -11.4433 +8615 4 26.7959 5.51316 38.5398 -27.2991 -6.53191 -16.0548 +8616 6 52.1237 17.2497 22.5073 -27.4301 16.765 14.7973 +8617 4 52.9399 17.665 22.2571 16.5652 5.20466 -11.3284 +8618 4 52.1578 16.3131 22.3678 7.8945 -19.2066 -9.92552 +8619 6 39.5302 30.1999 31.4498 -15.3908 2.56685 75.4769 +8620 4 40.0207 30.5437 32.2484 0.473519 -4.28305 -35.1019 +8621 4 38.713 29.8928 31.926 18.6512 10.8404 -28.7426 +8622 6 19.6503 6.93083 12.7623 15.8343 -24.4908 21.6207 +8623 4 19.8732 6.46228 13.5959 -20.1786 11.9342 -5.76682 +8624 4 20.303 6.55009 12.1776 -0.0209149 2.55819 -14.5973 +8625 6 32.4196 37.4972 40.0987 12.4446 10.4582 -32.0511 +8626 4 32.8186 36.647 40.0719 9.51079 -23.9505 -16.9607 +8627 4 32.1638 37.519 40.9804 -20.9873 13.1856 56.2462 +8628 6 39.7646 0.344956 6.09395 -0.813604 -13.3118 11.6504 +8629 4 40.0929 1.25666 6.05063 3.72657 -6.06719 5.14874 +8630 4 40.1279 41.7919 6.88268 -2.2039 13.7644 -10.8213 +8631 6 28.7754 10.1494 29.1547 6.27663 8.45441 -17.0952 +8632 4 27.8341 10.1814 28.9557 -5.13507 -0.906004 3.81537 +8633 4 28.9096 9.91312 30.0774 -3.02611 -6.60467 -0.689697 +8634 6 28.3509 21.0738 10.6423 20.1214 -0.517468 -23.7169 +8635 4 28.7452 21.9678 10.604 -10.1652 -7.70852 11.001 +8636 4 28.9796 20.5469 10.1008 -17.263 7.26144 14.8814 +8637 6 27.0689 28.6853 20.8654 35.4789 -5.63144 4.47554 +8638 4 27.7442 29.2307 21.3162 -7.53329 -4.62114 -3.00727 +8639 4 26.2324 28.9644 21.1916 -29.8949 8.87289 15.491 +8640 6 39.6884 13.9755 33.4499 14.6401 2.99861 16.5486 +8641 4 40.0373 13.7827 34.3426 -3.85296 -1.51256 -14.2832 +8642 4 38.7457 13.8219 33.5285 -9.87208 -9.87778 -3.27097 +8643 6 25.4679 11.6581 34.316 -5.2989 -28.5582 40.5924 +8644 4 24.7613 11.1605 34.7897 20.9725 -0.466275 -6.59756 +8645 4 25.003 12.0579 33.6214 -16.717 25.3404 -32.2266 +8646 6 27.5101 37.647 21.4263 -39.7295 -31.2682 -35.969 +8647 4 28.2375 37.1633 21.0518 17.2189 -6.02702 -9.55939 +8648 4 27.8241 38.1534 22.1272 30.3423 24.6719 41.8853 +8649 6 30.5838 20.0489 28.6446 73.221 13.9737 -1.42059 +8650 4 31.1441 19.3945 29.1273 -28.9524 12.9537 -8.0961 +8651 4 29.6632 19.9528 28.6439 -45.0502 -19.2043 6.90743 +8652 6 42.3833 1.8554 14.9243 13.367 3.08275 38.4467 +8653 4 41.8907 2.29225 15.634 5.99337 6.74303 1.17955 +8654 4 41.7769 1.84183 14.2131 -17.6385 -4.20156 -32.9301 +8655 6 12.1633 12.5377 19.5325 -23.0245 -19.867 -11.1113 +8656 4 12.9521 12.0237 19.3369 9.43068 0.576721 5.46819 +8657 4 11.4219 11.8853 19.4518 12.4737 16.4774 1.27947 +8658 6 19.216 1.20416 16.3541 12.5689 2.54581 22.2585 +8659 4 19.6937 0.628292 16.9879 -4.91383 6.35485 -14.1526 +8660 4 19.7889 1.98236 16.2594 -2.22189 -4.72354 -7.2618 +8661 6 9.47695 16.1439 27.6873 23.0793 15.684 -40.8775 +8662 4 9.87411 15.9669 26.7875 -8.00596 11.4199 30.6292 +8663 4 9.27844 15.2819 28.0019 -12.6146 -24.0632 14.4486 +8664 6 40.4558 26.1873 24.7848 -5.87099 -8.07067 -10.9608 +8665 4 40.3772 26.6753 25.6381 -3.45584 0.121614 -18.2296 +8666 4 40.075 26.6842 24.0102 9.21367 0.234889 33.0434 +8667 6 47.6742 17.6493 18.027 -37.0889 26.6143 -3.73366 +8668 4 48.2089 18.0323 18.7522 -4.76487 -3.2939 -8.20899 +8669 4 46.8388 18.2201 17.9217 41.9344 -19.3622 12.4897 +8670 6 36.6073 25.2802 4.19388 18.2149 -9.73143 -24.5863 +8671 4 36.604 25.3887 5.14943 -0.00537736 13.7381 3.83127 +8672 4 37.3627 25.7621 3.76942 -18.9403 0.329358 18.8416 +8673 6 39.5721 35.375 29.6682 7.39129 29.0443 4.37935 +8674 4 38.9992 34.6325 29.7528 -8.39079 -18.7886 -5.10368 +8675 4 39.3389 35.9401 30.4162 6.41301 -4.37294 -4.4287 +8676 6 0.402862 14.6299 13.3406 12.3375 -5.37043 -32.3015 +8677 4 54.737 15.2477 13.6388 -5.18731 7.44473 4.40324 +8678 4 0.540834 14.0191 14.0401 1.19186 -14.994 25.3978 +8679 6 12.2127 27.3484 8.43247 -29.2387 -0.771708 1.75024 +8680 4 12.965 26.7512 8.46983 14.5311 5.0326 6.8656 +8681 4 12.3156 28.1607 8.97491 11.1816 -11.3427 -11.9337 +8682 6 36.8986 14.8167 21.1188 31.0797 27.7575 -31.2238 +8683 4 37.0397 14.394 21.9547 2.6333 -10.7207 26.6181 +8684 4 37.7308 15.3371 20.9125 -24.2604 -24.0664 4.77074 +8685 6 20.8464 4.94114 21.1044 31.4042 5.97012 13.2179 +8686 4 20.3644 5.60924 21.5958 -5.50293 4.43366 -4.7096 +8687 4 21.773 5.03668 21.4416 -23.5272 -13.3128 -11.683 +8688 6 36.7544 1.79945 7.61694 -30.3574 47.6061 45.3867 +8689 4 36.327 2.6686 7.87118 16.8784 -26.1974 -29.8241 +8690 4 36.8428 1.50799 8.53455 15.1793 -22.3797 -11.8231 +8691 6 12.2439 31.5023 37.4569 -32.4985 -2.96535 6.06153 +8692 4 12.7586 31.1596 36.7365 10.4364 1.05198 -9.11954 +8693 4 11.3919 31.0227 37.3953 11.2973 8.58078 9.3944 +8694 6 38.9908 41.586 16.881 -5.73716 8.1645 -10.5856 +8695 4 39.3046 41.7073 15.9766 4.30886 -9.33368 3.06156 +8696 4 39.3667 0.405687 17.3669 3.77504 10.3777 9.96207 +8697 6 31.8904 27.2678 22.2602 -2.97266 4.85738 -46.2508 +8698 4 31.2122 26.6002 22.3915 1.88455 0.488126 10.0993 +8699 4 31.7489 27.4981 21.2895 3.71213 -3.79941 38.8104 +8700 6 42.7405 9.18554 25.589 -22.1194 -12.6454 -9.25487 +8701 4 42.0872 8.82691 24.9599 0.650449 1.17306 7.26361 +8702 4 43.4011 9.54846 25.0154 21.3216 10.0262 -4.62936 +8703 6 50.9383 28.1736 25.3544 -13.6318 0.0171378 28.1732 +8704 4 50.4953 27.5553 24.7803 -5.9639 1.72187 -15.2616 +8705 4 50.5272 27.9992 26.2251 14.2447 5.57945 -12.3971 +8706 6 43.1888 19.6578 30.9105 -66.6531 23.7889 25.5358 +8707 4 44.0873 19.829 30.8982 70.1332 9.75906 -5.84371 +8708 4 42.7965 20.4661 31.3425 9.97757 -17.7871 -10.1322 +8709 6 30.6644 14.0457 40.7997 -18.1309 16.7334 54.243 +8710 4 30.3214 14.3504 41.7092 15.0959 -2.90855 -40.5845 +8711 4 30.1739 13.231 40.7145 -1.19418 -16.8866 -12.4659 +8712 6 20.9131 15.4897 23.0235 5.61878 12.7036 12.8066 +8713 4 20.368 16.1905 23.4302 1.66694 -9.32372 -6.67403 +8714 4 21.8218 15.751 23.2692 -7.37195 -9.57776 -6.18749 +8715 6 34.2171 0.764056 35.8253 8.40959 -35.3498 44.9304 +8716 4 34.6567 1.46863 36.3417 -5.08936 -9.30099 -7.81199 +8717 4 34.1194 41.866 36.4755 2.29033 39.9746 -37.3302 +8718 6 38.9162 36.9098 35.9203 10.0793 6.80115 3.36275 +8719 4 39.7784 37.1612 36.3284 -16.0364 -11.2649 -5.21842 +8720 4 38.6132 36.0588 36.2696 9.66804 2.35098 0.533126 +8721 6 45.1336 25.2146 22.7744 -28.8992 3.863 21.2581 +8722 4 44.1561 25.0943 22.7165 17.1243 8.87651 18.653 +8723 4 45.3983 24.7563 22.0047 17.0602 -12.3694 -29.5411 +8724 6 40.597 0.8134 35.9421 3.227 69.6319 -3.88491 +8725 4 40.5509 41.8059 36.0096 -6.03355 -53.2669 -4.53187 +8726 4 39.9427 1.13471 35.2813 10.0151 -17.6297 16.5691 +8727 6 11.0455 28.3465 35.0235 9.7668 1.71998 -0.601403 +8728 4 10.9819 27.7367 35.7737 -0.960779 4.073 1.47136 +8729 4 10.3922 29.0422 35.1677 -11.8786 -4.48184 3.12795 +8730 6 20.2051 13.5934 35.8566 39.7213 -43.4527 45.4399 +8731 4 19.4813 14.0017 35.4777 -48.9883 30.031 -35.164 +8732 4 20.9868 14.0394 35.5673 14.4182 15.1 -18.5178 +8733 6 39.6245 5.13776 1.76997 -0.951619 9.89005 21.073 +8734 4 38.8252 4.77089 1.41386 -14.9185 -6.12031 -3.7056 +8735 4 40.3018 4.93211 1.13633 15.4903 5.30459 -14.5773 +8736 6 30.2698 30.8736 32.4375 -6.71798 15.6036 14.0469 +8737 4 29.6901 31.1438 33.1751 5.76607 1.99955 -8.25679 +8738 4 29.7896 30.1731 32.0039 1.14172 -17.9152 -6.50707 +8739 6 14.5598 11.0088 22.8703 10.5759 -0.53797 13.7125 +8740 4 15.2344 11.6195 23.3114 -32.0235 -23.0075 -11.5695 +8741 4 13.848 10.7777 23.5118 19.1574 10.2796 -1.34673 +8742 6 20.7379 13.9443 3.00881 5.16887 -45.0314 -26.4616 +8743 4 19.9261 13.6658 2.50706 22.866 18.233 23.793 +8744 4 20.5244 14.6819 3.55007 -16.1173 25.3417 12.2311 +8745 6 41.3029 4.28468 12.6203 -8.04128 10.917 21.7417 +8746 4 40.6152 3.63858 12.7642 -6.82471 -4.23516 2.09603 +8747 4 41.6484 4.11485 11.7651 11.719 -9.67534 -28.974 +8748 6 10.8581 24.7328 21.7161 -39.3585 -15.8792 -33.4515 +8749 4 10.0068 24.8598 21.1989 28.1112 14.2693 20.1969 +8750 4 11.1639 23.9123 21.3137 10.3572 -6.50453 7.69671 +8751 6 53.5762 20.8825 34.3773 -29.6915 -0.0415475 -3.94304 +8752 4 54.5085 20.795 34.3185 33.8519 4.29786 -2.30511 +8753 4 53.2552 20.0612 34.7861 8.83511 12.9473 -9.59804 +8754 6 14.8838 4.84499 30.449 -1.65326 0.839716 -13.8987 +8755 4 14.8578 5.00753 29.4799 -4.93385 -7.75961 17.951 +8756 4 14.5437 3.94124 30.5804 2.28716 7.27432 -2.63088 +8757 6 48.9137 37.1159 13.1232 -44.1315 32.6594 -31.0851 +8758 4 47.9268 37.1149 13.1949 24.5681 4.85746 10.1076 +8759 4 49.2024 36.4546 13.7037 17.9017 -30.2536 24.0784 +8760 6 26.8017 19.3068 7.5379 -15.1037 -1.6612 14.6377 +8761 4 27.3245 18.5243 7.34583 -2.01051 -6.65035 -9.19035 +8762 4 27.3053 20.0577 7.2492 18.4232 10.5976 -10.0514 +8763 6 17.631 11.9383 39.0904 -43.3265 13.8677 10.122 +8764 4 18.4941 11.6307 38.9203 38.4816 -13.6738 2.54756 +8765 4 17.5009 12.0978 40.0481 6.31677 -1.58465 -10.4285 +8766 6 49.9233 14.5931 8.61354 5.83785 -36.2985 -8.08798 +8767 4 49.214 13.9285 8.60404 6.89175 6.08198 5.75816 +8768 4 49.5175 15.3796 8.93642 -5.42274 33.9852 6.11405 +8769 6 32.3642 34.9667 31.5078 2.95354 23.7899 20.5819 +8770 4 32.072 34.4222 30.8036 -4.84614 -18.7532 -16.6478 +8771 4 32.4643 35.8463 31.1217 -0.970967 -0.757054 5.3462 +8772 6 11.8286 22.2266 21.3061 -17.2258 -15.6378 -41.9552 +8773 4 12.2171 21.6669 20.5638 -11.8041 19.7065 26.8676 +8774 4 12.3859 22.1258 22.0497 29.6948 -3.02551 21.8379 +8775 6 33.8509 9.96106 13.6416 -14.3875 -24.3714 -53.1057 +8776 4 33.0123 9.50508 13.4028 8.15621 17.9807 22.2309 +8777 4 34.3201 9.78154 12.7883 7.50726 12.1846 28.7729 +8778 6 25.5192 36.3946 1.51103 -10.4602 3.19395 -11.4439 +8779 4 26.0842 36.7323 0.810141 8.62195 6.50952 5.56913 +8780 4 24.6933 36.9065 1.40961 6.72848 -10.059 1.65156 +8781 6 26.2721 10.5411 9.76409 -19.2005 -4.19702 2.88354 +8782 4 25.6096 11.193 9.42675 5.9346 -6.99241 18.1855 +8783 4 25.839 9.94226 10.4354 7.43867 25.8511 -14.7334 +8784 6 25.016 0.794303 40.8954 13.3669 6.17095 4.00755 +8785 4 25.3682 0.342397 40.1084 -6.19889 9.04785 1.09472 +8786 4 25.4075 1.69244 40.9338 -2.19893 -14.7289 -5.24662 +8787 6 46.2434 3.93626 24.8203 6.94819 -22.6825 -8.03363 +8788 4 46.3834 4.04208 23.8743 3.61713 6.01616 -2.12387 +8789 4 46.2394 2.96647 24.9181 -8.37252 7.22853 3.62774 +8790 6 21.5889 13.6037 29.2057 4.95103 8.76674 17.4208 +8791 4 21.6019 14.3052 29.8879 -2.51331 -9.966 -5.68557 +8792 4 21.3126 14.082 28.4253 -2.16645 0.501775 -6.52993 +8793 6 36.7737 38.3803 0.360926 -13.0762 -25.442 -6.6792 +8794 4 36.4499 39.0355 0.978203 -4.80976 12.188 0.88021 +8795 4 36.0266 37.7487 0.22189 15.835 12.8395 4.19355 +8796 6 19.3086 17.6338 24.0617 47.0109 35.6134 -17.5995 +8797 4 18.4263 17.3722 24.1632 -50.3154 -15.1751 2.93786 +8798 4 19.3137 18.3511 23.365 -2.62926 -22.9616 14.087 +8799 6 23.1803 12.6945 3.50697 -12.4047 4.12184 -0.296296 +8800 4 22.2521 12.9621 3.30307 10.5621 -3.58256 -0.535563 +8801 4 23.3663 11.8631 3.0578 -9.23841 -1.30096 -1.53094 +8802 6 37.8891 8.88353 35.4651 -18.9945 -25.3999 -47.3866 +8803 4 38.8166 8.83127 35.1934 2.77199 2.98421 7.2207 +8804 4 37.4068 8.32521 34.752 23.9265 29.6152 37.0755 +8805 6 14.3237 15.1253 36.1844 10.7536 -1.62675 -12.1114 +8806 4 15.0418 15.7291 36.3902 7.37284 -3.65767 0.0646607 +8807 4 13.765 15.154 36.9379 -17.7819 2.51157 18.8211 +8808 6 35.0801 0.941274 33.018 -10.8249 30.7834 33.3167 +8809 4 34.9269 1.883 33.2395 6.71896 -7.58638 -28.1375 +8810 4 34.9733 0.615676 33.9226 0.339269 -19.4543 -11.259 +8811 6 50.9271 0.518298 17.9933 -4.01299 -8.33658 -1.61011 +8812 4 50.7551 1.39133 17.5891 -0.713529 -12.5397 8.99793 +8813 4 50.17 41.8323 17.8017 14.8721 13.6567 -6.57092 +8814 6 26.2328 30.5636 0.934374 -8.95911 39.2037 50.9017 +8815 4 26.9657 31.1139 1.27364 -12.5333 -13.1029 -5.86431 +8816 4 26.5352 30.0815 0.207089 19.4446 -20.9762 -37.1203 +8817 6 18.5681 38.3031 4.5613 16.0408 -0.4472 -12.493 +8818 4 17.6336 38.3732 4.40187 -16.7548 5.85511 1.82222 +8819 4 18.9561 38.7121 3.75593 -0.616515 -6.35836 15.3023 +8820 6 31.1349 5.07457 4.1166 35.5071 -12.4218 -11.0008 +8821 4 31.9258 4.61163 4.53765 -37.2933 13.7034 -13.5003 +8822 4 31.2792 5.02565 3.1391 -9.10044 -1.2591 17.9933 +8823 6 26.4378 21.892 1.49191 0.117022 -23.7737 9.75083 +8824 4 26.3504 22.7277 1.07049 4.38069 30.3527 -12.7348 +8825 4 27.3618 21.6023 1.50897 -0.762137 4.81239 -9.09803 +8826 6 39.2154 11.7026 22.7855 15.1366 1.14561 24.1899 +8827 4 39.8619 11.6546 23.5153 -3.42244 7.72178 -8.31759 +8828 4 38.7922 10.855 22.8508 -11.0077 -10.6036 -7.38167 +8829 6 13.6049 36.3215 30.6697 16.8779 70.0034 -37.8159 +8830 4 13.9417 37.1302 31.1268 -10.116 -30.1168 -5.71441 +8831 4 13.4922 35.6039 31.2515 -3.36872 -19.2676 30.0327 +8832 6 50.5831 9.86782 9.34675 -39.9446 -18.2052 0.719337 +8833 4 49.679 9.5553 9.65542 27.7691 6.62521 -8.8993 +8834 4 50.7343 10.6656 9.84378 7.47556 12.1458 9.31829 +8835 6 49.6659 40.3022 22.5839 -5.95569 -23.2057 2.00246 +8836 4 49.9088 39.3695 22.3976 1.04597 17.1639 -6.42107 +8837 4 49.3089 40.2511 23.4853 9.00681 3.37443 -0.55643 +8838 6 7.21026 41.318 28.8937 -13.882 28.5523 32.2899 +8839 4 7.13277 41.6426 29.851 5.74914 -19.7174 -37.6289 +8840 4 7.14599 0.215754 28.3517 11.7183 -8.26627 3.5395 +8841 6 13.0317 18.008 25.3351 57.1177 45.3919 41.6622 +8842 4 13.702 18.0765 24.6297 -18.9881 -2.87884 -2.05071 +8843 4 13.5608 18.5052 26.1022 -41.5403 -41.2906 -37.5185 +8844 6 50.0508 19.5822 2.43378 8.05757 -12.3534 -25.4868 +8845 4 50.6415 19.2321 1.70522 -9.91294 15.3245 28.3035 +8846 4 50.4964 20.3068 2.88656 9.48594 2.0046 -2.18375 +8847 6 28.3417 40.9623 24.5247 28.1527 -9.28969 -2.11238 +8848 4 28.8808 40.6229 23.7869 -8.53201 1.00989 5.926 +8849 4 27.851 41.6822 24.1702 -24.0642 17.3603 -12.6153 +8850 6 19.4173 5.36544 29.5282 -16.7292 -1.42659 17.4998 +8851 4 20.0576 6.03033 29.2802 12.6037 1.87093 -5.71578 +8852 4 18.8017 5.84191 30.1159 0.735032 -8.12986 -7.95209 +8853 6 35.3107 40.1454 22.2712 -2.40765 19.7984 -7.699 +8854 4 35.7006 39.9699 23.1142 6.54418 -16.9762 14.0951 +8855 4 35.2702 41.1078 22.294 -0.592679 0.794763 -5.20647 +8856 6 16.1889 33.7724 9.7458 10.3229 10.2088 29.582 +8857 4 15.8959 33.2543 9.01299 -6.07516 -13.8809 -16.7379 +8858 4 15.6715 34.5759 9.82028 -7.73583 2.776 -7.11592 +8859 6 17.3675 40.6445 20.2267 0.0256395 24.2963 -9.09373 +8860 4 17.2094 39.7816 20.6122 1.5629 -5.58702 6.23448 +8861 4 17.4758 41.3298 20.9152 1.51783 -13.2527 0.49298 +8862 6 20.5171 9.72867 9.58726 35.059 7.05341 -25.1666 +8863 4 21.2226 9.96362 10.213 -13.2653 -0.810893 -5.91795 +8864 4 19.8248 9.38464 10.113 -26.7953 -13.816 19.6743 +8865 6 47.4426 20.1922 21.3765 55.2231 -18.8128 34.629 +8866 4 48.295 19.6294 21.3384 -41.3243 22.9169 -3.74061 +8867 4 46.9816 20.0754 20.5659 -14.9725 -5.50706 -31.0177 +8868 6 38.4071 40.79 37.8146 12.3234 -22.6201 -9.80787 +8869 4 38.1404 41.7017 37.8605 -3.64711 23.1989 -4.06141 +8870 4 38.2696 40.4362 38.6954 -10.1247 -0.131598 9.15413 +8871 6 4.78578 1.94641 13.1038 0.280311 5.55092 -8.42179 +8872 4 4.79931 1.2475 12.4246 2.88607 5.75183 11.0778 +8873 4 4.58324 1.57529 13.9639 -2.31824 -10.9024 4.61034 +8874 6 46.8249 29.0091 2.16845 3.76482 2.94797 40.2579 +8875 4 46.7332 29.1215 3.14399 -15.0191 0.321828 -28.5005 +8876 4 47.6691 28.5689 2.15078 10.7116 -9.65214 -17.1948 +8877 6 37.4359 26.1653 25.6478 9.30824 1.4869 -5.75173 +8878 4 37.1837 25.5346 26.3178 -5.80587 -7.25577 3.90549 +8879 4 36.6384 26.5534 25.3025 -7.59782 4.42715 -0.0787482 +8880 6 27.3269 4.19583 19.442 5.96538 17.8772 -24.7701 +8881 4 28.0114 4.58146 18.8428 -3.77368 -14.8915 15.8068 +8882 4 26.5277 4.61529 19.0816 -6.14884 -6.84507 9.70558 +8883 6 29.57 35.1706 32.6629 9.65469 -19.4491 -13.9626 +8884 4 29.5306 34.4116 32.0191 -0.1659 24.8691 21.1709 +8885 4 30.4743 35.5004 32.5856 -0.51053 -0.290213 -2.43375 +8886 6 51.6097 27.3863 34.6091 -31.2455 30.913 9.06642 +8887 4 51.929 26.6019 35 16.42 -40.5282 7.55135 +8888 4 52.0725 27.582 33.8009 7.9649 -1.59603 -13.3915 +8889 6 26.2078 15.7281 22.6941 16.538 -21.7488 31.7554 +8890 4 25.9667 16.5615 22.3191 -8.70869 23.0893 -12.8942 +8891 4 26.0629 14.9994 22.0993 -9.54979 -3.97748 -17.7982 +8892 6 36.1239 41.1986 15.4707 -7.45359 -19.8962 -4.3143 +8893 4 35.6999 40.3419 15.2987 -9.47391 11.3121 -0.409552 +8894 4 37.0386 40.9374 15.4513 15.7433 3.85103 -0.545832 +8895 6 18.465 8.81345 11.2165 5.38391 10.0618 1.17025 +8896 4 18.7987 8.15135 11.8182 8.53154 -1.35082 11.1952 +8897 4 17.7161 8.38168 10.8393 -16.7411 -2.38381 -11.2186 +8898 6 30.2088 21.3096 23.2049 -11.6688 7.62645 -9.73036 +8899 4 29.9671 22.1993 22.9248 4.97058 -0.914249 3.78278 +8900 4 29.5299 20.7541 22.7893 7.94877 -1.13118 2.47612 +8901 6 22.73 2.20521 34.8374 1.74432 -25.8699 49.3747 +8902 4 22.3572 1.29354 34.8889 6.16039 22.5731 -10.8251 +8903 4 22.7018 2.4887 33.9486 -6.75325 10.5307 -40.1895 +8904 6 12.6909 2.75059 12.3422 -14.3125 16.3183 -13.6311 +8905 4 12.533 3.61796 11.8786 11.7453 -23.2619 14.9881 +8906 4 13.1336 2.19907 11.6816 1.83842 1.45343 3.2847 +8907 6 24.107 30.0639 14.5719 -73.5796 11.8292 4.65098 +8908 4 23.699 30.7611 15.1345 32.1371 -0.343623 -0.31889 +8909 4 23.2337 29.7156 14.2286 43.085 -3.68866 -7.89372 +8910 6 0.015177 27.9048 22.8533 -2.756 -4.53229 -2.63487 +8911 4 54.6492 28.3778 23.623 -8.36257 -3.01834 -6.1652 +8912 4 54.216 27.6514 22.3224 8.23112 8.70814 10.2495 +8913 6 12.3617 4.4844 25.9108 40.9735 -25.7794 -17.3291 +8914 4 12.201 5.40791 25.8162 -22.6464 21.2272 1.21762 +8915 4 11.6198 4.00067 26.267 -15.5784 4.93476 10.9426 +8916 6 50.6578 14.4652 5.91353 -13.9437 -6.30553 43.3918 +8917 4 51.4397 15.014 5.76935 2.55266 2.90763 -3.8133 +8918 4 50.4787 14.4827 6.92851 9.15248 3.54798 -49.9389 +8919 6 52.5668 22.873 20.1428 -12.6564 -29.9263 -28.8801 +8920 4 52.956 23.3393 20.8718 4.45243 13.9606 14.107 +8921 4 52.7899 23.3428 19.3246 -0.129831 10.341 11.583 +8922 6 43.5892 16.524 12.8775 29.595 -3.78245 -19.1347 +8923 4 44.3058 16.0087 12.3806 -28.6005 27.9094 23.6723 +8924 4 42.7982 16.4888 12.3437 -11.2315 -8.54457 -10.2035 +8925 6 15.9661 16.7487 40.5866 1.44034 32.7745 -1.20572 +8926 4 16.4126 17.3388 39.9207 -12.1014 -18.8104 17.452 +8927 4 15.5985 17.3766 41.2587 12.5036 -14.614 -16.5617 +8928 6 23.4158 18.8712 23.8473 -16.0774 -11.4939 3.2157 +8929 4 23.4518 19.2692 24.728 -0.157295 3.62127 -3.85719 +8930 4 22.4941 18.9757 23.5436 12.0607 -0.266031 2.57498 +8931 6 46.4178 3.27548 31.8952 19.5415 -1.29071 -17.2416 +8932 4 45.5866 3.26999 31.4067 -8.61336 -0.166695 4.01481 +8933 4 46.2657 3.3297 32.8359 -5.35267 1.32166 2.09612 +8934 6 43.4045 41.0584 12.2875 -8.04746 -23.5947 4.76735 +8935 4 43.6693 41.8276 12.7696 6.05224 12.9314 10.8988 +8936 4 43.5172 41.2728 11.3626 0.904796 3.93503 -13.2342 +8937 6 7.4976 32.4756 29.5884 -13.7893 55.6862 -12.0377 +8938 4 8.07142 31.7837 29.8334 27.4303 -26.9633 6.13269 +8939 4 8.04212 33.3166 29.512 -13.0153 -27.2422 -1.65156 +8940 6 4.77821 31.644 22.4997 2.28771 28.4048 16.4959 +8941 4 5.27411 32.2412 23.0928 2.56389 -13.4484 -8.63656 +8942 4 4.12057 32.2584 22.1518 -1.39427 -10.0394 -7.16978 +8943 6 48.879 26.8662 2.67919 -5.86075 -60.7959 24.9619 +8944 4 49.7001 26.7095 3.23946 -26.2991 7.4186 -32.0291 +8945 4 48.3448 25.9902 2.75892 28.4546 51.6452 -6.88552 +8946 6 35.3626 23.261 21.6242 -2.7789 -2.57103 6.54281 +8947 4 36.2261 22.8974 21.81 4.94258 -15.6751 6.88864 +8948 4 35.5426 23.9136 20.9639 -1.02428 17.548 -23.8062 +8949 6 9.79934 37.7758 27.3048 16.52 16.637 17.9603 +8950 4 9.72643 38.6113 27.803 -16.1555 -8.36248 -12.7831 +8951 4 10.5885 37.4189 27.7206 -2.15823 -16.4776 -5.60851 +8952 6 6.95685 10.9812 25.9821 -25.178 -21.2877 -4.97438 +8953 4 6.33357 10.2528 25.7268 23.179 21.9129 0.503821 +8954 4 7.29095 10.6974 26.8328 9.60603 -1.481 14.6966 +8955 6 15.9965 34.4888 38.9273 -2.91878 -3.91161 19.3063 +8956 4 16.0374 33.5463 38.7461 4.95306 -0.665665 -16.4822 +8957 4 15.9715 34.4958 39.9054 -7.59103 5.72172 -22.2107 +8958 6 24.1167 17.3197 36.1615 15.3363 -47.5124 0.380375 +8959 4 24.7173 17.5753 36.8648 1.58194 5.49031 12.5141 +8960 4 24.1546 16.3101 36.2205 -9.7187 30.8811 -7.11116 +8961 6 29.9757 19.0472 5.63639 12.788 -31.6225 11.2379 +8962 4 30.1584 18.5328 6.46799 -12.7316 12.501 -21.5451 +8963 4 29.4206 19.7916 5.84051 -11.4929 16.6696 15.0892 +8964 6 41.2293 14.2018 25.873 -1.75888 28.9255 -23.3251 +8965 4 41.1078 15.0995 25.4693 3.83492 -22.0907 13.098 +8966 4 41.2654 14.3268 26.8215 3.7207 5.50516 9.94654 +8967 6 30.6006 17.7874 37.3562 -24.7598 46.8721 10.074 +8968 4 30.0173 18.4181 36.8416 23.2796 -25.9316 -1.25214 +8969 4 30.633 18.2764 38.2118 8.15578 -14.795 -8.30511 +8970 6 36.2662 35.7599 28.8527 -12.8707 -30.9202 21.2821 +8971 4 36.6718 34.9534 29.2396 -10.1595 12.442 -4.1956 +8972 4 37.0218 36.2801 28.6478 17.3511 22.2532 -11.5483 +8973 6 0.195836 37.8645 20.3851 -23.6217 6.21569 -13.9532 +8974 4 0.549498 37.2778 21.0637 4.94615 -2.95215 -2.70832 +8975 4 54.3862 37.4234 20.0075 16.4722 8.11718 6.90773 +8976 6 49.5165 39.5896 25.2714 -0.622408 -34.3922 32.9891 +8977 4 49.1772 39.7667 26.1925 10.9208 -1.11318 -32.3029 +8978 4 49.8261 38.6352 25.2806 -10.9036 35.658 1.81375 +8979 6 21.6574 10.1952 29.3538 -5.06277 -0.743802 10.2318 +8980 4 21.4664 11.1105 29.223 -3.01111 19.5458 -20.3057 +8981 4 21.662 10.2064 30.3052 9.73006 -17.7161 13.8831 +8982 6 36.4636 30.0567 0.119709 9.37859 61.6807 38.5429 +8983 4 36.3123 29.4684 41.3206 -1.21017 -23.1836 -37.505 +8984 4 36.9143 30.908 41.7057 -13.4567 -39.5067 4.20368 +8985 6 35.2344 23.3726 39.1433 31.8417 -88.9919 -51.9106 +8986 4 35.0278 23.5012 38.2069 -5.96056 -5.38998 8.96032 +8987 4 34.9909 24.127 39.538 -31.8308 96.9265 45.0865 +8988 6 25.4761 17.6258 38.7257 1.29934 8.28965 -16.1346 +8989 4 26.2031 17.0769 39.0234 13.7946 -6.33455 1.86524 +8990 4 25.7107 18.4933 39.0598 1.3782 7.33891 4.86011 +8991 6 32.6846 1.71002 15.3734 -11.6254 -20.3205 21.5399 +8992 4 32.9453 1.93093 16.3086 -8.96834 -8.53877 -20.2534 +8993 4 32.154 0.853232 15.3925 19.204 32.1949 4.36426 +8994 6 2.7574 26.2382 40.1716 -4.40087 -21.6692 -50.7652 +8995 4 2.38718 26.7949 40.8139 -8.13358 26.7101 38.7547 +8996 4 3.41358 25.6429 40.5298 13.0891 -5.49009 7.80053 +8997 6 25.4307 39.5752 6.64887 -26.4755 -1.32722 14.1102 +8998 4 25.8932 39.0809 7.30961 27.038 -6.17916 -3.25304 +8999 4 24.5458 39.4465 7.03066 -2.44587 12.932 -21.9634 +9000 6 3.88975 2.45855 21.1879 28.3389 -91.355 -25.6726 +9001 4 3.44478 1.54109 20.9736 25.4092 48.4753 9.01111 +9002 4 3.19228 2.99847 21.4284 -47.2055 43.8768 12.3888 +9003 6 19.4353 35.9908 6.17834 -1.98144 -11.1023 18.0698 +9004 4 18.7425 35.7628 6.83514 2.39623 12.5316 -16.1317 +9005 4 19.0828 36.5127 5.45195 -11.0597 11.4176 1.1294 +9006 6 53.664 10.8386 34.7899 -0.427116 -3.27611 41.7292 +9007 4 53.6105 10.6836 35.7561 -1.66612 -17.5448 -26.7849 +9008 4 53.9652 11.7272 34.8329 4.68725 29.9217 -18.2793 +9009 6 51.2799 14.0867 34.6651 -29.2798 -10.9719 -23.3019 +9010 4 50.6522 13.5411 34.1107 26.8684 18.9114 5.01949 +9011 4 50.9895 13.8814 35.5479 1.81167 -5.08277 17.6681 +9012 6 14.4338 40.0198 28.0288 -0.147098 23.5255 27.6002 +9013 4 13.7688 39.3521 27.8218 1.28331 -8.25373 7.75106 +9014 4 14.1948 40.5222 28.8704 -0.878391 -19.6822 -29.209 +9015 6 36.0552 40.8569 1.29319 48.4065 13.1893 15.2608 +9016 4 35.4421 41.0883 1.96787 -21.4185 -0.412662 13.5205 +9017 4 36.896 41.2683 1.66088 -27.5471 -12.7345 -18.5843 +9018 6 32.5846 21.8706 9.62772 14.4951 6.80277 0.680584 +9019 4 32.1936 21.3098 8.97285 -7.2875 -23.9506 -7.81502 +9020 4 32.858 22.6104 9.08324 0.955029 10.0343 1.40437 +9021 6 53.7602 11.4574 10.0748 -7.70253 -4.89045 -17.0247 +9022 4 54.6558 11.7035 10.3272 3.70339 -10.2166 -5.16833 +9023 4 53.8328 10.8374 9.31644 -2.27357 5.83713 13.9933 +9024 6 25.443 2.0669 35.0212 -16.7533 17.7231 -21.4763 +9025 4 25.6415 2.91576 34.5502 -7.64634 -16.7974 11.4347 +9026 4 24.4652 2.09352 35.1703 17.3945 -2.11295 -4.26167 +9027 6 38.4088 16.3775 27.0777 23.4896 -26.556 7.92078 +9028 4 38.4029 15.905 27.9411 -0.72651 18.7119 -5.4255 +9029 4 38.1233 17.2789 27.1678 -4.67214 15.3602 11.0072 +9030 6 11.9834 11.8283 38.0863 1.50515 -20.9897 -19.5245 +9031 4 12.337 12.445 38.7318 -5.05033 4.06408 7.46746 +9032 4 11.0493 11.6049 38.244 7.06215 11.5652 6.68382 +9033 6 21.1646 40.7247 25.8949 30.8575 -6.32012 -20.5276 +9034 4 20.7152 41.4784 25.5554 -14.4662 20.9939 -18.0031 +9035 4 20.8194 40.6451 26.758 -13.9443 -15.9826 36.5019 +9036 6 5.45737 31.2526 28.1092 12.1805 15.5126 -2.48606 +9037 4 4.77986 31.7446 27.6301 0.776808 -0.764161 -8.53258 +9038 4 6.21204 31.8695 28.2031 -7.61365 -6.18966 7.74582 +9039 6 38.5666 10.4345 26.6322 12.4833 -8.23035 1.5222 +9040 4 39.2815 10.9281 26.2104 -2.91177 1.8082 -0.00903947 +9041 4 39.0293 9.89744 27.2937 -7.88948 5.75886 -1.98766 +9042 6 34.5704 22.2441 5.77364 -5.35359 -6.12765 6.5276 +9043 4 33.6261 22.329 6.01336 10.9983 8.59631 1.2651 +9044 4 35.1361 22.6291 6.46875 -10.1328 -5.43064 -4.61746 +9045 6 19.508 23.4157 8.91293 -5.78488 4.73981 5.04963 +9046 4 19.7274 23.1974 9.83518 1.16663 -6.94775 -9.92836 +9047 4 19.9131 22.8043 8.29809 9.12387 -6.1547 2.91491 +9048 6 19.7424 39.1606 18.9462 6.36032 12.2479 8.14591 +9049 4 20.3561 39.0422 19.6872 -3.85164 -4.35394 -5.20149 +9050 4 19.0738 39.7495 19.3414 -1.06489 -8.07777 -11.9442 +9051 6 19.0057 16.6591 37.8853 37.3334 -16.7993 4.17439 +9052 4 18.1861 16.4809 37.4823 -32.8062 -2.38488 -19.1553 +9053 4 18.8146 17.2984 38.5514 -2.10283 15.4454 14.1988 +9054 6 46.1541 18.3125 34.4675 -16.9871 7.29415 15.254 +9055 4 46.1595 17.7325 33.7168 0.615393 -10.1859 -17.2384 +9056 4 45.2376 18.6499 34.5058 9.28079 -5.03019 -2.85447 +9057 6 37.6537 4.93165 10.635 20.1552 -8.04423 -16.7256 +9058 4 38.5399 5.21744 10.272 -26.6503 -7.30776 7.98139 +9059 4 37.1074 4.55852 9.88971 22.9932 21.6332 27.1334 +9060 6 51.9792 36.004 6.8478 30.791 3.18545 -0.726681 +9061 4 52.2413 36.7963 6.35992 -14.9215 -4.55469 -2.53046 +9062 4 52.8266 35.8818 7.33626 -22.3254 6.63746 5.40006 +9063 6 26.6741 12.3268 1.0034 -10.7024 -25.4666 -34.2692 +9064 4 26.4988 12.3574 1.94138 -4.81655 1.43394 14.8604 +9065 4 26.0954 11.585 0.663483 16.9242 17.5219 15.4646 +9066 6 51.3423 35.7724 13.5298 -0.266216 29.5034 10.6004 +9067 4 51.4043 36.4131 12.804 2.34884 -4.4098 -1.45811 +9068 4 51.4073 34.9167 13.1542 5.41074 -27.2154 -15.541 +9069 6 1.98873 3.64285 24.5869 25.9971 69.8048 -55.2188 +9070 4 1.65752 3.03018 25.1632 -30.3002 -46.9535 54.3289 +9071 4 1.71436 4.54846 24.8879 2.6309 -26.2008 -0.982747 +9072 6 33.5221 15.2795 16.4506 0.0536135 -15.838 -38.1617 +9073 4 33.6476 15.3964 15.4593 -8.63578 3.82522 35.1416 +9074 4 33.7341 16.1085 16.8736 8.85342 14.4801 4.37501 +9075 6 10.7227 26.5775 37.3442 -67.903 54.2831 -20.645 +9076 4 10.2191 27.0779 38.0369 14.5194 -13.2702 -3.80745 +9077 4 11.4784 26.2608 37.7268 68.0232 -30.094 41.6962 +9078 6 39.6271 8.38119 31.999 1.44949 -5.13238 35.1009 +9079 4 39.1996 8.85287 32.7464 5.61163 -5.5592 -21.3265 +9080 4 39.0885 8.45634 31.2221 -15.3514 9.3045 -12.0182 +9081 6 48.873 24.2439 11.5987 1.10357 -37.2725 -9.21005 +9082 4 49.1825 23.3167 11.4023 -5.65288 27.9965 8.32055 +9083 4 49.5986 24.6511 12.0826 3.19491 3.15896 -2.50749 +9084 6 15.8098 8.51994 22.5326 -12.5814 0.672941 2.19285 +9085 4 15.7588 8.52265 21.5683 10.3815 2.49136 4.36748 +9086 4 15.4206 9.36801 22.7863 6.5895 4.65597 -0.371293 +9087 6 16.9392 23.5364 7.95083 25.1749 21.5498 -34.0775 +9088 4 17.2079 23.9031 7.093 -25.8979 -5.01679 3.50755 +9089 4 17.8126 23.4623 8.29573 16.7216 -7.09478 32.6865 +9090 6 42.4825 26.8555 6.33102 0.60087 7.54144 -12.7632 +9091 4 41.764 27.4892 6.46083 9.75026 1.01062 3.5184 +9092 4 43.14 27.3488 5.78659 -9.42643 -3.33158 7.6404 +9093 6 36.8078 4.79995 30.0438 -4.74249 18.2042 -3.85385 +9094 4 36.952 4.89746 30.9922 3.10706 -1.8894 0.559973 +9095 4 36.294 4.02131 29.8808 -10.4691 -15.4659 3.71438 +9096 6 45.6128 11.6142 3.31163 15.5246 21.1623 13.6733 +9097 4 45.8972 10.701 3.31117 0.727629 -14.3179 7.30305 +9098 4 46.2501 12.0834 3.90994 -13.3278 -10.7206 -15.6492 +9099 6 24.8943 36.3842 21.2731 0.145584 -0.0155718 21.9832 +9100 4 24.5073 36.3627 22.1568 -5.92138 3.86098 -2.91089 +9101 4 25.79 36.6624 21.4916 7.30899 1.2523 -13.3669 +9102 6 31.8172 24.7218 2.44079 24.9542 32.077 -0.738567 +9103 4 31.5948 23.8911 2.82575 -7.26237 -24.1795 3.52598 +9104 4 32.7966 24.7848 2.51706 -20.2581 -1.29655 -5.98664 +9105 6 24.135 21.9795 37.225 -18.6422 57.7065 19.5247 +9106 4 24.1223 22.9841 37.1061 1.06209 -41.2434 9.50937 +9107 4 24.7129 21.6948 36.5371 13.1815 -12.7877 -24.1492 +9108 6 37.1979 11.5342 15.06 20.8972 -17.7328 -40.5152 +9109 4 38.0246 11.7972 15.4709 -1.33045 5.21986 19.7962 +9110 4 36.429 11.9138 15.4438 -18.178 22.6449 25.793 +9111 6 36.4751 20.3399 41.7845 -26.5497 -48.0551 41.2862 +9112 4 36.3228 19.4621 41.3748 1.60744 11.8178 -3.29004 +9113 4 36.9246 20.873 41.191 27.5593 28.4699 -43.2619 +9114 6 32.0497 37.9214 32.6612 -32.2386 -8.50634 -18.7459 +9115 4 32.4337 38.7163 32.9803 20.8647 20.5609 12.2985 +9116 4 31.3654 38.2694 32.0613 5.31663 -14.2519 5.69849 +9117 6 12.0395 39.928 22.5123 -26.9832 36.7812 23.3187 +9118 4 12.2839 40.8414 22.1926 -3.01474 -29.6796 4.86816 +9119 4 11.2932 40.0883 23.1662 29.524 -10.585 -25.0576 +9120 6 26.3406 1.33526 19.2893 15.6729 -20.8034 13.8388 +9121 4 26.8411 0.655996 19.8199 -14.5491 24.9752 -14.9066 +9122 4 26.8003 2.1813 19.3861 0.112049 0.00336314 -1.02908 +9123 6 5.91669 14.3164 5.69097 2.29729 -16.5161 -30.3395 +9124 4 6.30102 14.1024 4.7902 -6.32478 5.25084 23.5077 +9125 4 5.06552 13.8494 5.70115 7.33482 -6.30923 1.55114 +9126 6 13.3703 23.089 19.1627 -28.3895 15.3871 14.4757 +9127 4 14.1086 22.8122 18.6632 27.2898 -8.01563 -16.6587 +9128 4 13.6991 23.742 19.8005 3.67942 -13.964 0.879599 +9129 6 23.4058 15.0688 9.73621 -4.11719 1.06855 12.2005 +9130 4 22.5732 14.661 10.02 0.657405 4.9462 -7.25364 +9131 4 23.2196 15.7347 9.05868 -5.70535 0.38861 -5.0655 +9132 6 49.5812 13.8288 18.4474 0.101153 1.0527 41.008 +9133 4 48.8214 13.4814 17.9923 -8.96247 -7.71084 -15.1851 +9134 4 50.2052 14.1722 17.8367 10.7879 13.5653 -33.2962 +9135 6 41.7444 5.67096 41.8915 25.5819 0.859229 17.1787 +9136 4 42.5704 5.9364 0.475256 -21.6624 -6.74737 -14.5764 +9137 4 42.0361 4.9893 41.2645 -5.04703 6.59959 -2.77397 +9138 6 17.2492 35.5437 2.55512 -4.98919 17.2489 6.23124 +9139 4 18.1963 35.629 2.41282 7.59523 -3.20753 1.41995 +9140 4 16.9663 34.6563 2.38439 4.57262 -16.6324 -5.73806 +9141 6 49.6936 19.8647 40.242 36.1149 -8.05295 1.41344 +9142 4 49.24 19.0314 40.466 10.1916 2.45634 3.62304 +9143 4 50.6901 19.7225 40.3055 -34.6505 -2.12616 -4.55887 +9144 6 38.3055 5.83107 32.0437 -25.1209 3.13983 17.5072 +9145 4 37.8566 6.51058 32.5952 5.57321 -12.5864 -8.78808 +9146 4 39.2068 6.11217 32.0045 20.6085 6.27671 -1.8315 +9147 6 16.2656 6.85278 34.0134 13.6308 -7.44031 -0.955967 +9148 4 16.5278 6.7006 33.1016 -0.686465 1.61317 -6.98637 +9149 4 17.0706 6.57794 34.496 -11.7464 5.49098 9.02554 +9150 6 33.6779 18.1919 10.4599 39.833 -25.9405 -6.08719 +9151 4 34.2274 18.843 9.984 -7.48822 -11.4027 6.26591 +9152 4 34.2403 17.3374 10.5556 -30.6671 44.9369 -7.76686 +9153 6 38.8896 33.7563 36.7672 22.7659 10.9801 -36.8997 +9154 4 38.4264 33.5452 35.9055 8.66825 7.19978 21.2858 +9155 4 39.8358 34.0039 36.5278 -27.7603 -15.0244 3.77145 +9156 6 45.3747 13.0912 20.2115 -8.54575 18.1695 38.2532 +9157 4 45.1986 12.6554 19.3957 -4.2418 -14.8759 -23.2281 +9158 4 44.5273 13.1029 20.6991 7.89471 -4.73094 -13.0554 +9159 6 36.3919 32.2126 8.83938 1.15121 -2.28434 -1.4136 +9160 4 36.3207 31.3933 9.34391 1.93757 3.36082 7.91897 +9161 4 36.0586 32.9456 9.38554 -3.10773 -8.06217 -4.51958 +9162 6 7.93399 27.8164 6.18652 -8.84441 8.26416 -30.5327 +9163 4 8.20753 27.2416 6.88401 9.15323 -7.03573 14.7081 +9164 4 8.30192 28.6748 6.41842 -5.04409 0.971707 0.751098 +9165 6 14.2889 4.87494 33.6812 -48.074 -5.72289 -27.637 +9166 4 13.5426 5.15568 33.0467 38.2298 -5.02982 23.8683 +9167 4 14.8103 5.65434 33.8518 10.0815 16.0504 2.39638 +9168 6 12.247 8.64363 9.86387 9.5307 8.47707 -42.9656 +9169 4 12.7265 8.83196 10.6522 4.83417 -1.95201 32.3898 +9170 4 11.3733 8.28369 10.003 -7.27928 -7.56138 14.4849 +9171 6 29.7193 31.982 8.5339 -11.3757 5.45371 -22.6092 +9172 4 30.2272 31.7973 9.28681 18.5431 -1.21859 37.4341 +9173 4 29.7513 31.1489 8.05875 -9.95983 -0.182644 -6.87416 +9174 6 22.3912 10.8818 21.4749 22.6973 -30.3469 0.856054 +9175 4 21.7953 11.1177 20.7819 -19.5872 13.8984 -18.5017 +9176 4 22.3568 11.5583 22.1363 -13.7305 16.7548 8.89642 +9177 6 54.1825 27.5382 12.9949 16.0749 -34.873 29.2784 +9178 4 0.169556 27.5337 13.075 -9.84187 5.32432 -2.29215 +9179 4 53.8855 28.25 12.4714 -3.97587 36.1158 -26.3516 +9180 6 7.7322 13.8127 20.037 -51.4252 10.19 -38.2554 +9181 4 8.32211 14.101 20.6974 26.6579 16.8549 28.1402 +9182 4 7.28001 14.6396 19.6917 19.816 -24.9044 7.79538 +9183 6 19.8038 0.841082 24.7751 2.23798 25.7663 18.7115 +9184 4 19.2888 0.974936 25.5977 -1.44078 2.26272 -14.328 +9185 4 20.345 1.66892 24.688 -12.1486 -28.8133 2.35345 +9186 6 3.00622 10.0987 2.94957 -26.3714 23.4248 -9.90714 +9187 4 2.57802 10.9845 2.80681 8.85648 -28.8297 5.38 +9188 4 3.90714 10.2978 3.18407 20.8138 3.7803 5.2 +9189 6 15.8735 13.0135 24.0167 27.3456 -6.4848 -7.35342 +9190 4 15.0397 13.4574 24.067 -14.2007 12.8972 1.61729 +9191 4 16.3075 13.2711 24.8409 -0.511489 -7.63656 -0.0548578 +9192 6 17.0843 4.34635 26.9246 21.6007 -4.50946 14.2865 +9193 4 16.8972 4.2188 26.0046 2.50265 0.324122 -20.691 +9194 4 18.0611 4.2338 26.9976 -18.2314 5.96709 -0.11875 +9195 6 33.6189 39.4094 10.6341 -20.462 51.0085 -28.6484 +9196 4 33.9391 38.663 11.0702 20.9333 -51.253 8.17882 +9197 4 33.8334 39.409 9.67256 -1.15733 -4.02232 18.0774 +9198 6 36.2391 1.10544 13.1071 -14.4853 9.25302 -40.2412 +9199 4 35.5849 0.422507 13.2928 -0.138393 -8.38057 10.5121 +9200 4 36.8138 1.26142 13.8363 9.41155 -3.27129 23.8008 +9201 6 40.853 19.2974 5.10856 37.2457 -28.9827 71.4026 +9202 4 40.5429 19.587 4.3016 -40.6732 16.7295 -57.0845 +9203 4 40.1307 19.0416 5.7147 0.644924 10.2678 -10.4268 +9204 6 2.34714 37.5568 10.1845 35.9634 7.02123 17.8242 +9205 4 3.04769 37.1203 10.7322 -14.847 6.26565 -12.1612 +9206 4 1.86424 36.8893 9.71962 -14.8151 -24.6966 -11.8987 +9207 6 8.10127 29.0413 15.8656 35.302 -29.7249 12.8686 +9208 4 9.00843 28.6191 15.9508 -31.5464 15.4715 -14.0583 +9209 4 8.16404 29.7921 16.4466 -1.11054 13.1495 4.82257 +9210 6 47.3142 26.5199 12.5393 12.6514 34.6971 -22.5506 +9211 4 47.5805 27.2834 11.915 -17.373 -39.4708 28.4474 +9212 4 47.3752 25.7188 12.0092 -0.907674 -0.00416251 -5.94845 +9213 6 33.5917 17.5154 0.659811 -43.6991 -50.8046 22.4668 +9214 4 32.6165 17.4611 0.916402 33.9721 22.4374 -10.1482 +9215 4 33.8023 16.5556 0.790839 15.7196 25.0769 -8.55135 +9216 6 38.9785 15.6005 36.3846 -2.2974 -5.19358 -9.56289 +9217 4 39.1604 14.6481 36.4599 -0.972636 7.263 -3.41001 +9218 4 39.314 15.9159 35.5329 5.29716 -3.31476 -2.44888 +9219 6 34.8185 34.3512 9.36223 6.47638 -43.1481 -28.0847 +9220 4 35.4473 34.9875 9.0418 9.26483 22.2324 -9.2882 +9221 4 34.4241 34.6992 10.1221 -17.9819 29.7233 40.2724 +9222 6 44.963 2.56985 14.7807 31.4374 15.1132 5.36654 +9223 4 44.0324 2.49792 14.9225 -24.9873 -3.38313 6.1219 +9224 4 45.264 3.39221 15.2058 -8.16761 -2.00961 -7.57881 +9225 6 42.6004 38.2794 19.8329 35.0217 22.8895 -33.2683 +9226 4 42.7468 39.1886 19.4383 -9.39889 -30.5105 9.50416 +9227 4 43.174 37.7101 19.2395 -23.2435 10.9907 19.5876 +9228 6 18.6884 26.768 30.2631 -44.5574 -6.69712 -17.565 +9229 4 18.1049 26.7773 29.4546 19.8507 -1.43152 25.0232 +9230 4 19.5658 26.9377 29.9555 24.8572 5.14496 -8.76909 +9231 6 38.8622 37.7231 16.4658 -22.8479 4.5656 13.1257 +9232 4 38.7902 36.7734 16.2818 1.44729 8.74588 -1.32739 +9233 4 39.7766 37.9619 16.5567 26.2519 -3.67716 3.06508 +9234 6 49.2941 9.82087 12.5338 42.2108 35.2088 45.7943 +9235 4 48.9089 9.29765 11.888 -36.0338 -29.0733 -40.4243 +9236 4 48.6148 10.195 13.1058 -6.01968 0.395602 -5.44143 +9237 6 43.2224 7.37144 19.82 -8.13737 3.26926 23.5272 +9238 4 42.5007 7.77471 20.3735 21.5488 -7.79487 -11.5807 +9239 4 44.0862 7.49788 20.2643 -6.92785 0.102081 -4.68832 +9240 6 36.344 38.7219 4.42923 6.60518 -8.27287 -3.54737 +9241 4 36.8681 39.515 4.62823 -9.591 -1.38231 4.53716 +9242 4 35.4251 38.8858 4.67742 1.90858 4.69501 2.45497 +9243 6 27.7906 17.7903 15.1063 3.75124 -7.8529 -14.6222 +9244 4 27.6041 16.8818 14.7764 0.112743 20.8749 5.00331 +9245 4 27.89 17.7299 16.0573 -1.67078 -3.69001 6.73869 +9246 6 18.0934 3.7697 37.3166 -37.4896 -7.94699 -19.9181 +9247 4 18.6099 3.0373 36.9676 7.8944 1.98274 4.30106 +9248 4 18.6508 4.23334 37.9126 25.9725 10.5984 22.5053 +9249 6 7.70643 11.5866 6.5218 3.89219 -35.3855 26.5153 +9250 4 7.81247 12.3986 6.99593 -0.830342 19.7116 4.35361 +9251 4 7.69429 11.7375 5.59555 -1.18048 8.56411 -33.1609 +9252 6 31.493 14.3493 18.0362 -8.33789 -14.4781 24.6772 +9253 4 32.1359 14.6991 17.4236 11.1505 2.18599 -11.6706 +9254 4 31.9992 13.8221 18.6877 -1.72215 8.99473 -5.41338 +9255 6 50.3257 30.4119 8.91981 13.6638 2.66477 0.921327 +9256 4 49.6699 30.7962 8.33415 -6.09837 5.9585 -1.44957 +9257 4 50.0726 29.5063 9.09532 -3.6785 -2.74239 1.52637 +9258 6 42.1666 10.1001 12.7665 27.8846 0.568566 -7.78474 +9259 4 41.2574 9.89168 12.6212 -25.0269 -7.71108 -1.23548 +9260 4 42.2044 10.927 13.2385 -4.76175 6.29789 8.61568 +9261 6 37.7726 3.10257 32.5651 17.7286 -33.908 -11.3576 +9262 4 38.1655 3.96622 32.6549 -5.80606 19.6252 0.391082 +9263 4 36.8286 3.11418 32.7073 -14.5698 15.7581 5.48125 +9264 6 35.7529 13.1025 19.269 15.6222 -22.7979 5.95892 +9265 4 36.108 13.8438 19.7616 3.89933 6.86159 4.70877 +9266 4 36.3275 12.3403 19.5267 -16.9537 12.3267 -5.61016 +9267 6 45.5307 4.12701 21.4866 3.53751 -14.4086 10.8893 +9268 4 45.552 4.15257 20.5178 1.20389 1.85135 1.62688 +9269 4 45.7304 3.20168 21.7391 -1.66454 15.9633 -13.005 +9270 6 16.8818 1.84763 31.4809 -38.7514 34.7723 -17.791 +9271 4 16.1373 2.3559 31.0688 16.7124 -32.2776 -3.52377 +9272 4 16.9707 2.38347 32.2636 22.4894 -8.71684 18.7287 +9273 6 14.088 4.88632 23.5804 12.6338 -46.5447 -4.7054 +9274 4 13.8705 5.7909 23.7155 -14.7558 31.001 11.1078 +9275 4 13.7332 4.31383 24.2952 -4.17517 18.1368 -8.36436 +9276 6 38.3179 33.7515 12.3711 -25.6361 -5.15185 -28.4625 +9277 4 38.1256 32.9508 11.8227 6.04426 17.9062 13.2724 +9278 4 39.1779 33.654 12.756 21.0695 -5.21903 12.1581 +9279 6 35.6902 3.04562 37.6746 -3.39904 8.35156 -7.25132 +9280 4 35.0929 2.54933 38.2324 -5.1037 -10.0227 3.00486 +9281 4 35.8394 3.86187 38.1597 5.81883 9.20211 1.39187 +9282 6 31.3375 37.3986 35.3773 -3.71028 -11.6357 31.0668 +9283 4 32.2621 37.6229 35.4422 12.7398 8.80293 9.59752 +9284 4 31.1956 37.5429 34.4696 -8.56261 0.879722 -41.7472 +9285 6 52.0699 11.7425 14.0188 13.7235 -2.71131 -30.9774 +9286 4 51.8967 11.0942 13.2788 12.7756 18.36 20.3091 +9287 4 52.777 12.3878 13.7226 -29.9657 -23.6346 9.26958 +9288 6 26.3494 3.44143 41.0133 25.155 -37.875 16.6614 +9289 4 25.5593 3.94137 41.1232 -17.1598 23.2709 -17.7277 +9290 4 26.8278 3.58917 40.1822 -8.59815 12.7626 -4.44352 +9291 6 24.371 34.9599 11.1571 26.4033 32.6711 -2.50587 +9292 4 24.3639 34.5741 12.011 0.42503 -6.32387 38.1824 +9293 4 23.9976 34.2869 10.6415 -25.866 -31.4028 -29.8537 +9294 6 32.0031 7.59722 31.2247 -0.72006 7.33901 18.8157 +9295 4 32.1508 7.36357 30.327 0.345644 0.817488 -27.7554 +9296 4 31.6126 8.48818 31.2118 -2.13527 -8.40442 2.30992 +9297 6 28.7291 2.6069 0.424694 -24.9548 -1.7826 -18.2237 +9298 4 29.2265 2.34055 41.548 2.55638 3.32464 9.52498 +9299 4 27.7798 2.59721 0.142899 25.7986 3.33204 9.63582 +9300 6 42.1267 19.2107 9.86358 19.9254 -1.00598 31.807 +9301 4 42.7282 19.2504 10.675 -28.0191 -3.63038 -32.4782 +9302 4 41.4654 18.506 9.99331 2.41107 5.70909 -2.24499 +9303 6 33.0117 27.0899 8.33041 6.96541 -9.8522 -22.9567 +9304 4 33.8754 26.9804 7.88875 -4.89246 2.6856 6.68054 +9305 4 33.1889 27.2976 9.23992 7.88062 7.04275 14.0068 +9306 6 4.17016 8.31297 19.162 0.312608 -23.727 -31.8356 +9307 4 4.57057 7.90515 18.3575 7.98956 13.418 22.158 +9308 4 3.24181 8.25888 18.9046 -6.31749 7.79174 9.16769 +9309 6 20.797 29.1851 37.0682 -78.8245 -16.0462 -5.4556 +9310 4 20.936 28.2326 36.9784 16.4861 -0.723813 3.66436 +9311 4 21.5674 29.6886 37.0761 54.0195 18.5923 4.39527 +9312 6 13.113 4.99943 10.9253 0.843453 12.9862 -7.21248 +9313 4 13.3812 5.91092 11.1622 0.48683 -16.0572 0.936043 +9314 4 12.7752 5.03128 10.0238 -4.21215 6.55392 -0.64752 +9315 6 37.5015 18.1018 32.5195 21.2703 25.6519 14.9603 +9316 4 38.1786 18.7738 32.2234 -25.3038 -17.5123 8.13315 +9317 4 37.1867 18.4103 33.3985 6.70568 -0.056708 -13.7279 +9318 6 17.7491 33.2689 30.7387 4.64458 14.8517 -20.1826 +9319 4 17.8421 33.9996 30.1068 1.39741 -2.79987 6.34018 +9320 4 18.5541 33.2627 31.2599 6.50121 5.74528 2.59283 +9321 6 23.1871 32.777 9.90494 7.13269 10.4795 -4.3903 +9322 4 23.4604 31.94 10.2921 1.41378 -5.3263 0.807867 +9323 4 22.2339 32.7251 9.74224 0.938735 -0.283076 -0.953242 +9324 6 14.8916 9.36878 34.2544 -3.17606 -9.25219 -4.09189 +9325 4 15.4257 8.57154 34.1751 4.23415 -4.52565 -0.814207 +9326 4 15.1936 9.94604 33.5417 3.33837 13.7034 4.88209 +9327 6 31.123 39.3556 38.5725 10.4581 -15.7875 9.507 +9328 4 31.6408 38.6334 39.0195 -17.0405 19.4438 -10.5616 +9329 4 30.3963 38.9123 38.1137 2.26745 0.847431 0.999129 +9330 6 5.28935 34.441 28.2777 -1.85934 -10.7383 -20.8922 +9331 4 5.27738 35.3973 28.3959 -1.64374 -0.931958 4.82044 +9332 4 5.15855 34.3195 27.3212 3.56171 0.206479 13.9304 +9333 6 30.3161 21.6889 14.1169 -2.08187 28.5408 26.4102 +9334 4 30.4824 20.7856 14.3415 3.20532 -20.0191 -7.60805 +9335 4 30.3589 21.8902 13.1869 1.55029 -10.1196 -17.5522 +9336 6 23.85 39.0046 28.2977 69.4329 26.2515 4.57453 +9337 4 23.9916 39.6084 27.5499 -13.57 2.08121 2.63988 +9338 4 23.036 38.5875 28.2612 -60.5143 -23.8938 -11.8576 +9339 6 9.59742 13.5396 16.4589 33.261 19.9292 -8.86772 +9340 4 8.78625 13.0496 16.3926 -14.9619 -4.96746 -5.567 +9341 4 9.78335 13.9533 15.5888 -9.09133 -14.4247 9.50074 +9342 6 25.9705 6.17968 15.7985 42.799 -23.1477 28.9675 +9343 4 26.019 6.01901 14.8637 -2.75181 4.35539 -17.3872 +9344 4 26.7603 5.64791 16.135 -36.9143 25.7793 -10.0513 +9345 6 15.9952 33.6108 22.5498 -1.32684 21.179 0.174096 +9346 4 16.0845 34.132 21.7265 -5.08009 -17.3545 9.33233 +9347 4 16.0452 32.6693 22.2946 2.44519 21.8582 -2.86748 +9348 6 40.6954 13.5457 12.1293 -5.68603 3.79069 10.9638 +9349 4 40.3939 13.0592 11.3555 -1.07855 -14.0058 -3.54454 +9350 4 41.0539 12.9031 12.7626 -3.06611 3.62129 -5.67307 +9351 6 35.5822 40.2773 31.6862 -1.2862 -13.706 14.6905 +9352 4 36.0451 40.9783 31.2154 -1.32327 -4.34646 -14.1397 +9353 4 35.653 39.3915 31.2603 0.648621 22.1552 -3.29488 +9354 6 19.3539 17.5757 17.8527 24.8545 64.4629 -5.36553 +9355 4 19.9703 18.4106 17.9379 -31.776 -45.1138 0.798127 +9356 4 18.7059 17.8424 17.1823 2.41282 -7.28307 3.58563 +9357 6 7.95249 28.0742 10.7793 26.3782 25.043 4.49745 +9358 4 8.50313 28.8396 11.0908 -15.1612 -19.5627 1.83511 +9359 4 7.20779 28.4792 10.322 -5.34026 -2.34355 -4.06419 +9360 6 32.1473 39.5951 16.6478 -17.9563 1.55165 -8.91142 +9361 4 31.6569 40.3908 16.3404 14.2892 -12.9666 6.03874 +9362 4 31.5266 38.8716 16.4637 6.06753 4.48602 8.64925 +9363 6 35.7883 2.63292 18.1275 9.48574 -34.9606 14.0071 +9364 4 34.8666 2.32593 18.1793 13.7366 6.70894 -2.41967 +9365 4 35.7792 3.51083 17.8116 -6.62646 29.9084 -15.3578 +9366 6 14.9404 39.9496 36.887 -3.95865 -34.2615 35.0372 +9367 4 15.4649 39.4425 36.2826 11.0028 -6.45738 -16.6057 +9368 4 15.0284 40.8419 36.6608 5.56286 51.7396 -15.8162 +9369 6 18.3052 32.4025 11.469 7.68428 8.43447 19.219 +9370 4 18.6311 32.5236 12.4045 -8.3236 -1.07971 -30.5152 +9371 4 17.8613 33.2392 11.223 7.02035 -14.738 0.639166 +9372 6 14.6021 10.381 5.00501 12.904 -5.64335 9.41677 +9373 4 13.6938 10.4305 4.69945 -10.3065 0.63937 1.1744 +9374 4 14.613 10.0418 5.92181 -1.23128 6.20644 -15.3767 +9375 6 2.02771 14.3355 39.1727 -5.84559 30.0988 4.34298 +9376 4 2.70173 15.0418 39.0898 -4.78946 -14.8923 5.30178 +9377 4 1.28797 14.7602 39.6738 10.0694 -17.377 -15.1558 +9378 6 7.58332 14.1556 32.4652 3.8824 27.7869 10.7592 +9379 4 6.9433 13.665 32.9756 -4.43494 -6.18284 1.69377 +9380 4 7.54129 15.0698 32.8492 6.23928 -24.1467 -15.6449 +9381 6 6.15722 23.1341 37.6504 -34.5618 -50.1938 -2.0692 +9382 4 6.56488 23.96 37.7745 13.4151 41.4847 -0.267706 +9383 4 5.38195 23.2242 37.0516 20.9526 5.02196 8.70483 +9384 6 37.2952 22.537 4.44472 51.3933 75.9823 3.75371 +9385 4 36.5074 22.1342 4.18978 -47.7056 -22.8011 -17.3868 +9386 4 37.221 23.5361 4.21623 -3.53185 -51.7458 12.1203 +9387 6 47.1368 31.0168 5.89375 -14.3926 17.1884 -69.1718 +9388 4 46.9718 30.7968 6.77028 -10.6218 -7.91998 56.0799 +9389 4 46.2684 31.351 5.53353 23.0456 -16.9797 4.17914 +9390 6 54.8109 25.5937 34.9376 16.0179 27.3393 -6.0446 +9391 4 54.0726 25.4665 35.5517 -1.08617 7.29827 -2.61058 +9392 4 0.161491 26.54 35.0366 -21.9365 -36.0956 3.57937 +9393 6 37.1499 2.07739 4.80452 -1.94348 22.0087 -45.3652 +9394 4 36.668 2.89852 4.54683 5.06511 -19.4283 11.9563 +9395 4 37.1062 1.96831 5.73813 -4.74438 -1.19387 27.2393 +9396 6 22.5142 28.609 8.91066 14.7838 -0.767913 33.3492 +9397 4 22.9803 28.3541 9.73828 -15.565 12.7605 -7.61321 +9398 4 22.8168 27.9481 8.31925 3.93055 -13.9923 -25.0246 +9399 6 8.64284 27.1533 24.5627 -30.3364 66.7798 9.61681 +9400 4 7.68564 27.0552 24.6389 4.16714 -15.7471 -5.05425 +9401 4 9.10482 26.3676 24.4825 22.9633 -64.4218 -6.53839 +9402 6 1.14841 23.7276 2.43845 3.37143 2.75553 -28.3576 +9403 4 1.24451 23.8913 1.47114 -2.40676 3.6179 20.3541 +9404 4 0.297784 23.2877 2.48462 -2.13531 -2.42607 6.29474 +9405 6 54.3749 30.2279 27.0351 -1.87188 5.01086 -25.6864 +9406 4 54.247 29.4439 26.4851 0.283672 1.58093 2.67322 +9407 4 54.589 30.9178 26.3677 -1.31459 -2.18642 16.2549 +9408 6 0.382292 8.43516 23.9819 16.8945 -11.9539 9.7221 +9409 4 1.32445 8.60369 24.1565 -2.20413 -11.2301 -8.89161 +9410 4 54.9553 8.73001 24.7921 -9.77823 11.7559 2.768 +9411 6 16.9131 28.5848 33.3683 -2.23593 -25.3201 -21.0962 +9412 4 17.3654 28.7863 34.1955 9.02781 -2.88055 -0.915496 +9413 4 17.3951 27.8627 32.8656 -13.2947 27.9561 26.4245 +9414 6 33.6945 30.8881 0.140848 11.5734 5.16226 7.65985 +9415 4 34.5903 30.4955 0.196618 -6.50407 7.83028 -3.90982 +9416 4 33.2725 30.4522 41.313 0.902851 -8.5209 -4.03004 +9417 6 16.2572 21.5133 34.1618 -1.32279 -12.2579 -0.0768877 +9418 4 15.8666 20.7686 33.6578 14.5936 10.7995 5.0381 +9419 4 16.7742 21.1109 34.8905 -13.5083 8.43335 -11.1581 +9420 6 0.208862 17.804 35.7536 -14.601 -29.9007 -2.72034 +9421 4 54.2286 17.807 35.5323 33.4083 9.0609 14.8615 +9422 4 0.362977 16.9429 36.1939 -0.60553 13.4006 -6.21859 +9423 6 16.8205 12.2987 0.018055 22.2965 10.2312 29.8095 +9424 4 17.2696 12.8062 0.753963 -11.4311 -8.71934 -28.0399 +9425 4 16.617 11.4478 0.422257 -11.1364 1.3302 -4.58262 +9426 6 8.24969 9.53941 36.253 -15.0171 13.8578 -6.15226 +9427 4 7.92627 8.96163 36.9484 -10.0154 -4.61382 -0.313479 +9428 4 7.46687 9.9886 35.83 14.4541 -3.15884 14.1629 +9429 6 48.5699 26.7153 39.8372 -6.05787 -6.72914 15.0837 +9430 4 48.3449 26.8926 38.9385 -16.4424 3.29077 -18.6566 +9431 4 49.4571 27.0352 39.8842 23.4859 3.73228 5.76721 +9432 6 35.4844 1.07048 23.1169 11.4549 30.8088 37.1655 +9433 4 36.0158 1.76714 22.6808 -9.17201 -14.7916 0.90361 +9434 4 35.6328 1.27141 24.1103 0.373025 -19.0496 -44.6811 +9435 6 20.2784 30.6315 19.3752 23.9103 -21.6662 15.3888 +9436 4 20.3116 31.0532 20.259 -5.42732 -3.95571 -8.57186 +9437 4 20.9344 29.8759 19.4191 -22.0709 25.9102 -5.54449 +9438 6 44.3706 15.9499 1.58551 5.68582 14.4456 12.9619 +9439 4 44.3685 15.5676 2.49167 2.87795 14.7015 -16.764 +9440 4 44.6274 16.9163 1.6094 -6.5628 -31.3198 6.45039 +9441 6 53.8881 34.4681 10.5864 -33.0496 11.7448 -26.9592 +9442 4 54.422 34.2751 11.3149 32.4161 -9.35278 40.7994 +9443 4 54.2788 35.2396 10.1584 -0.0979649 -6.0993 2.73708 +9444 6 46.1388 32.8516 33.5211 5.22207 -15.0187 3.22626 +9445 4 45.9452 33.6327 33.0044 -1.75723 11.2428 -3.91525 +9446 4 47.0422 32.5752 33.2841 -5.1447 4.42718 0.252344 +9447 6 42.1248 21.9061 24.225 29.3467 -8.59285 14.1471 +9448 4 43.0897 21.6191 24.2618 -39.2895 4.06832 7.69751 +9449 4 41.7308 21.6944 25.1042 13.707 1.91177 -18.5137 +9450 6 8.13464 3.90485 11.6471 19.3767 -1.70453 -18.8264 +9451 4 7.33962 4.19894 12.0861 -8.05938 -6.79837 10.6821 +9452 4 8.35918 3.01511 11.9412 -4.68297 1.80025 9.46807 +9453 6 19.6422 41.6776 9.83213 -10.6455 12.1827 13.5714 +9454 4 18.8651 41.1405 9.66265 4.99962 -3.76564 -7.41899 +9455 4 19.3487 0.264237 10.6212 9.02518 -11.5641 -14.6522 +9456 6 42.3073 8.42404 31.6799 28.9247 6.2763 -10.2166 +9457 4 41.4386 8.38933 32.0551 -18.7028 2.48038 0.978172 +9458 4 42.5266 9.37939 31.5704 -3.99861 -19.3235 1.7837 +9459 6 26.9144 16.155 25.3557 3.37886 4.46922 -29.1574 +9460 4 26.8932 15.8089 24.4276 -4.09623 14.1183 21.5023 +9461 4 26.5944 15.4425 25.8888 -2.2842 -17.5105 15.3426 +9462 6 48.2339 6.48607 12.6213 -2.32796 -4.32122 -9.13051 +9463 4 48.9884 6.29985 12.0375 -6.36801 1.93824 2.64233 +9464 4 47.4521 6.15437 12.1363 8.14441 0.739204 7.03502 +9465 6 53.4551 41.5313 30.6545 -6.55363 -20.9747 -16.7061 +9466 4 53.9707 41.8328 29.895 1.38615 3.54438 2.31965 +9467 4 53.5938 0.199493 31.3858 11.9182 14.0856 15.8016 +9468 6 47.0766 22.4304 31.8083 3.49024 11.2606 -9.33253 +9469 4 47.8957 22.458 31.249 -27.0486 7.80914 13.6686 +9470 4 46.5597 23.2507 31.6033 14.3992 -20.3875 6.89099 +9471 6 19.5103 5.43818 15.252 80.4346 7.77941 -36.259 +9472 4 19.9845 4.58151 15.2093 -6.94904 10.3389 3.32724 +9473 4 18.6939 5.26573 15.6196 -64.0069 -9.45641 27.6942 +9474 6 14.6723 30.2358 33.3977 29.3194 14.0021 -15.573 +9475 4 15.2147 30.9127 32.9173 -16.9191 -15.4944 5.99358 +9476 4 15.2716 29.4658 33.3729 -9.39086 7.05787 2.01807 +9477 6 28.44 24.2314 10.4028 3.15123 -12.4056 -9.54268 +9478 4 29.226 24.4262 10.8786 32.4584 2.85658 2.79411 +9479 4 27.8296 24.5485 11.0342 -36.3144 6.15546 12.0187 +9480 6 5.27118 14.4387 24.4945 35.1445 25.2092 -0.0633509 +9481 4 4.43594 14.1516 24.7736 -48.8682 -19.2375 4.52664 +9482 4 5.4685 14.0235 23.6561 -3.04719 -11.4521 -9.99341 +9483 6 26.3524 19.2908 19.1818 20.1263 -20.0506 -24.4735 +9484 4 26.6388 20.1349 19.5116 -1.98461 18.5008 5.62334 +9485 4 27.0961 18.9592 18.5977 -26.1102 9.18548 27.2368 +9486 6 28.5758 7.44193 13.1857 16.8206 36.5977 2.40675 +9487 4 28.4276 6.5743 12.8854 -8.83608 -34.241 -6.14436 +9488 4 29.1296 7.84613 12.4994 -7.23682 2.38597 3.89632 +9489 6 5.36882 27.1473 37.046 11.8823 -4.88323 19.1587 +9490 4 6.08575 26.9595 37.7076 -19.1456 -1.45009 -21.6041 +9491 4 5.36685 28.0942 36.8598 5.86896 -0.355799 -4.60773 +9492 6 53.1378 13.4025 16.0996 34.2435 -3.86055 5.06914 +9493 4 54.0829 13.0966 15.9504 -32.0077 5.91706 2.7318 +9494 4 52.5847 12.6783 16.4422 5.4814 -0.344951 -11.4066 +9495 6 45.452 1.01889 24.6154 3.31322 11.7394 9.54943 +9496 4 44.8157 0.989703 23.8982 -3.33354 -4.25493 -1.52857 +9497 4 44.9019 0.844105 25.4008 9.82267 -2.51687 -6.81685 +9498 6 50.1641 2.37547 13.9256 -5.79196 7.9049 4.59273 +9499 4 50.7992 2.78767 13.3238 -3.84891 -0.754592 0.637936 +9500 4 49.4746 3.0334 14.0873 2.34893 4.7321 -2.13859 +9501 6 19.5803 31.0161 39.1628 -18.0613 -25.9328 -11.5794 +9502 4 19.7424 30.2951 38.4816 -0.347779 24.7736 22.083 +9503 4 18.6224 30.9377 39.4182 28.2801 4.19594 -11.375 +9504 6 19.2561 14.7051 10.8744 35.9018 -50.5273 5.13524 +9505 4 20.0412 14.097 10.5737 -45.0165 49.548 5.48727 +9506 4 18.7602 14.0269 11.3662 -4.16951 16.5755 -2.6658 +9507 6 4.45594 39.5485 20.1375 -7.26247 21.8372 28.3356 +9508 4 3.95576 40.4005 20.2782 15.6699 -22.2203 -5.74536 +9509 4 4.87483 39.3065 21.0019 -15.4768 4.14169 -24.4646 +9510 6 29.0152 13.3442 23.91 8.01267 35.4951 15.4816 +9511 4 28.7225 12.4574 23.7464 -4.82052 -12.6612 5.31893 +9512 4 28.8407 13.5397 24.8723 9.679 -4.85246 -32.6651 +9513 6 17.068 2.76349 17.6602 17.5731 -10.7754 -19.6116 +9514 4 16.9152 3.43747 16.9733 0.569879 -2.90947 3.06519 +9515 4 17.8166 2.20316 17.3149 -21.6663 12.1671 7.12297 +9516 6 43.4725 18.0406 17.7144 -1.44781 -24.3706 15.3127 +9517 4 43.4291 17.0524 17.7495 6.1749 24.1268 -14.107 +9518 4 43.576 18.2305 18.6573 0.474252 7.4982 -2.94392 +9519 6 25.7765 40.7491 1.25834 -5.13784 -8.67992 -41.8469 +9520 4 26.3241 41.1434 1.92597 2.9618 17.1891 5.50682 +9521 4 25.7331 41.3641 0.469204 -4.81559 -13.5206 29.0343 +9522 6 0.465549 22.8917 6.22214 -2.55797 -7.94984 -3.9446 +9523 4 0.971697 22.1453 5.8424 -8.20264 3.34524 4.91565 +9524 4 1.09943 23.372 6.75946 4.60597 5.6548 -4.31438 +9525 6 26.241 35.011 18.6432 -1.36099 17.7753 -9.20742 +9526 4 25.9471 35.9461 18.6768 6.76043 -15.7179 -8.96745 +9527 4 25.6107 34.5957 19.2286 4.79325 -10.2415 3.05652 +9528 6 16.134 31.8742 7.55305 63.3701 -24.5537 -22.1036 +9529 4 16.96 31.3344 7.22221 -43.8871 18.402 28.1533 +9530 4 16.2567 32.6659 7.02685 -6.92396 6.43503 -6.66113 +9531 6 22.9365 16.8424 28.5556 -11.8911 28.7995 -6.03551 +9532 4 23.1131 16.1224 27.957 -2.92592 -13.6094 -7.1053 +9533 4 22.1672 17.3806 28.2048 22.5292 -24.3034 15.5849 +9534 6 48.8154 29.3426 32.1508 17.6607 -5.63259 25.101 +9535 4 47.9338 29.1776 31.8283 -15.752 -0.354552 -3.67809 +9536 4 48.876 28.9209 33.0523 -3.3832 13.4569 -22.7771 +9537 6 13.1275 24.861 5.55911 -24.9858 12.0714 -24.023 +9538 4 12.9095 24.1076 4.98414 3.68764 2.77663 3.09454 +9539 4 12.4428 25.5491 5.3163 19.4298 -17.0083 16.84 +9540 6 10.97 20.7168 15.838 25.2219 -21.2413 -18.4662 +9541 4 10.9273 20.4774 14.8836 -9.78471 10.8905 20.232 +9542 4 11.8407 20.3068 16.0784 -25.4832 11.5027 -0.03881 +9543 6 13.8668 18.3675 6.9377 -17.1805 34.1284 -15.5183 +9544 4 13.9861 19.3268 7.07801 0.95534 -8.68107 -9.41428 +9545 4 14.2312 17.9937 7.71618 14.696 -22.4056 21.3209 +9546 6 13.8328 12.9436 30.6366 23.8936 8.4875 1.93436 +9547 4 14.0561 12.5213 29.7889 -15.7862 -10.4805 9.2002 +9548 4 13.0857 12.5134 31.0734 -5.46762 -5.09599 -12.1481 +9549 6 17.1276 6.33232 31.2677 66.6528 76.8842 26.6004 +9550 4 16.7194 7.19542 31.0916 2.25558 -4.54354 -1.53399 +9551 4 16.4872 5.75051 31.0533 -74.7845 -70.3194 -26.0669 +9552 6 7.63688 23.4278 20.549 2.87884 3.81634 -6.68902 +9553 4 7.34623 23.1229 19.6666 2.94756 -0.449201 10.6329 +9554 4 8.04096 24.3016 20.3852 -3.87648 -11.4978 -1.95405 +9555 6 15.5875 36.6622 25.6317 44.8659 35.0544 -6.16252 +9556 4 16.5723 36.6215 25.7443 -25.3852 -14.6967 7.558 +9557 4 15.5456 37.5452 25.2115 -8.92727 -11.7797 -1.50769 +9558 6 0.738994 10.4213 22.1809 -27.1543 -36.2471 -13.1925 +9559 4 0.031346 10.3136 21.4752 22.4259 7.4169 21.1377 +9560 4 0.614162 9.62536 22.7539 0.837437 23.266 -16.3015 +9561 6 33.4753 17.3986 33.5966 50.0322 34.9653 -25.691 +9562 4 33.729 18.3684 33.3861 -23.79 -42.9591 12.1009 +9563 4 34.1104 16.8695 33.0603 -9.99519 5.32569 13.787 +9564 6 21.6594 19.0069 20.7632 22.9673 -17.6764 -6.78691 +9565 4 22.3468 19.6741 20.9606 -3.94962 -13.1079 -1.95693 +9566 4 22.1476 18.14 20.6003 -16.6978 33.0759 6.74927 +9567 6 41.7633 20.003 16.8748 -11.326 -1.31128 -8.84591 +9568 4 42.2034 19.1563 16.9874 6.48398 -7.2756 0.328325 +9569 4 41.4682 20.0367 15.9399 8.87316 5.12137 10.7952 +9570 6 12.0358 14.9766 17.6999 -26.21 -7.2152 -26.0517 +9571 4 11.2991 14.5498 17.1995 11.2858 13.8526 14.1879 +9572 4 12.4764 14.2447 18.105 9.10187 -13.3837 13.9354 +9573 6 23.0147 11.4211 40.7142 -19.9953 11.3897 74.5259 +9574 4 22.9359 12.2968 41.1901 4.60696 -23.5555 -21.1396 +9575 4 23.3157 11.5565 39.857 19.7433 14.0142 -51.5111 +9576 6 21.0056 28.3023 24.5803 -69.1041 85.2373 -40.9106 +9577 4 20.265 28.1264 25.1705 5.37048 -3.26467 3.49678 +9578 4 21.6928 27.7549 24.7451 59.1792 -66.0576 27.8401 +9579 6 19.39 13.7159 31.9239 29.4118 -13.0288 15.1298 +9580 4 18.7661 13.9847 31.2678 -13.3276 3.02657 -9.68553 +9581 4 18.8827 13.5849 32.728 -3.24577 4.6437 7.00982 +9582 6 21.5915 2.84466 24.7134 0.208747 24.5944 -29.04 +9583 4 21.6872 3.18692 23.7998 -4.92058 -5.74628 13.5023 +9584 4 22.4885 2.58061 24.905 3.18231 -12.543 15.1704 +9585 6 11.3458 29.9955 18.8336 12.03 22.8495 18.6886 +9586 4 10.5716 30.5896 18.8018 6.29595 -15.7791 -4.99952 +9587 4 11.9743 30.476 19.4324 -17.0963 -23.9187 -22.0967 +9588 6 14.6495 22.3648 8.3568 42.8177 1.00499 7.23029 +9589 4 14.0031 23.0587 8.53935 2.83958 6.20927 5.13977 +9590 4 15.5993 22.7606 8.33857 -60.0645 -13.0658 0.526795 +9591 6 43.9468 23.6541 17.2812 -2.43742 26.8438 -12.7514 +9592 4 44.7651 23.2701 16.9945 19.1668 -3.91001 -9.18188 +9593 4 43.5028 22.9 17.6346 -11.2125 -8.13016 15.2757 +9594 6 28.0047 25.4978 27.5091 9.49546 -35.4414 -7.32855 +9595 4 27.536 26.3032 27.53 -22.6173 33.7003 2.08289 +9596 4 28.9082 25.7508 27.3241 10.2254 5.98924 0.98151 +9597 6 19.1021 26.8113 33.1456 6.96794 1.44941 -44.6281 +9598 4 19.0009 26.3889 32.2316 6.61058 22.4795 36.193 +9599 4 19.4537 27.7357 32.9996 -8.5054 -25.835 6.12407 +9600 6 6.37601 19.3499 5.67113 -3.07724 -15.511 8.20386 +9601 4 6.68786 20.0294 5.07731 7.18653 8.65774 -7.7972 +9602 4 5.56195 19.7092 6.03854 -2.87224 2.62267 4.46635 +9603 6 37.49 28.403 9.68405 -10.2736 -31.6176 -26.4717 +9604 4 37.8518 27.9475 10.4351 5.1765 10.0485 19.5132 +9605 4 37.3493 27.6251 9.09625 -2.69325 25.3221 7.01666 +9606 6 17.6998 27.0953 11.7898 -36.7906 -34.4972 13.5582 +9607 4 17.0141 26.488 11.3694 25.6316 27.0728 3.78529 +9608 4 17.4298 27.07 12.7376 6.94557 14.4563 -18.9236 +9609 6 12.8888 1.93962 24.1529 -50.3802 38.9184 -15.728 +9610 4 12.0235 2.45928 24.1313 32.0413 -19.6529 -17.3906 +9611 4 12.9222 1.7892 25.0724 13.055 -19.4335 33.1456 +9612 6 27.8476 37.1183 33.3015 17.2618 -5.56645 -20.6455 +9613 4 27.8725 37.7306 32.5366 -3.66202 -8.07766 15.1749 +9614 4 28.4268 36.3488 33.0405 -13.8477 22.6944 8.61763 +9615 6 18.6736 12.3707 6.31908 6.91225 -31.4632 27.4828 +9616 4 18.6995 11.385 6.25383 -9.67628 20.7874 -2.26223 +9617 4 18.5836 12.6888 5.4344 -4.12511 6.2973 -26.1687 +9618 6 10.1784 29.305 24.7735 -9.10204 -23.9111 21.4033 +9619 4 10.6991 28.9855 25.5395 2.35147 16.2142 -6.30056 +9620 4 9.48939 28.598 24.7147 15.6456 22.7499 -9.47694 +9621 6 7.25796 3.28933 16.2737 -3.06701 21.6066 -7.53298 +9622 4 7.8017 4.02386 16.6541 -5.18893 -18.6288 5.77884 +9623 4 6.83195 2.7267 16.9458 19.6595 6.39335 -0.783342 +9624 6 32.1965 37.5589 1.11244 17.7564 -13.393 -49.4834 +9625 4 31.8113 36.9118 1.6863 -14.8068 -2.94474 23.9511 +9626 4 32.3136 38.4192 1.49585 -8.3749 16.0852 25.1081 +9627 6 10.4319 10.1504 6.4166 -7.63199 8.14139 10.6713 +9628 4 9.50403 10.3698 6.52583 -9.38347 6.87647 -8.77798 +9629 4 10.8186 10.5343 7.22249 5.92406 -9.68277 -8.25616 +9630 6 16.1813 23.2506 37.3799 25.1097 11.6639 -4.85114 +9631 4 16.5396 23.4181 38.2693 -7.5274 5.30939 -3.10176 +9632 4 16.7237 23.8262 36.781 -18.6662 -9.83464 11.0165 +9633 6 24.0859 14.3313 36.5421 -9.86516 7.30801 -0.382215 +9634 4 25.0278 14.1902 36.5644 12.4097 -8.07045 3.76472 +9635 4 23.7255 13.9571 37.3615 2.98939 6.5027 1.55174 +9636 6 27.4763 18.5532 28.7891 -13.5271 -4.91773 7.22809 +9637 4 27.279 18.1935 29.6763 -0.617381 3.48163 -16.8994 +9638 4 26.6639 18.4733 28.2428 3.34183 3.33207 10.806 +9639 6 51.5601 10.4909 1.56577 -57.9967 -14.5533 -18.7957 +9640 4 50.8004 9.99697 1.98849 19.2905 21.9947 -18.6033 +9641 4 52.233 10.462 2.20044 35.6887 -2.31897 35.1783 +9642 6 31.1159 39.6224 27.5035 10.1927 26.9633 6.19817 +9643 4 30.6636 39.3812 28.2975 -12.6206 -22.2416 8.82104 +9644 4 31.2642 40.5609 27.7597 6.49383 -23.2522 -24.0775 +9645 6 6.91312 35.9708 14.3252 -31.0555 -15.8542 22.3873 +9646 4 7.60399 36.2341 13.7609 26.7748 16.1612 -20.4248 +9647 4 7.14109 35.0698 14.5861 -2.88708 -0.858877 1.78829 +9648 6 45.5543 7.568 29.1737 -25.5302 -4.16762 -2.13202 +9649 4 44.8976 7.53234 28.4293 19.2773 0.699039 20.3251 +9650 4 45.0852 7.16669 29.9393 6.23602 2.26061 -10.7804 +9651 6 31.3622 20.562 31.6184 9.65463 4.63597 0.319717 +9652 4 31.8498 21.4034 31.7895 1.14978 -23.5084 -11.6884 +9653 4 31.8627 19.9392 31.0494 0.180852 16.2895 10.8054 +9654 6 43.0328 31.1512 10.3804 -22.1718 15.2565 33.5805 +9655 4 42.075 30.8844 10.4741 26.7443 4.92622 -3.29861 +9656 4 43.2631 31.5811 11.2548 -4.68507 -19.1463 -31.4268 +9657 6 50.935 25.5526 12.6381 -53.0362 -11.2381 37.5759 +9658 4 50.8444 26.3707 12.1889 6.26198 32.0523 -21.5557 +9659 4 51.7606 25.1556 12.4927 46.8244 -9.35474 -8.90879 +9660 6 29.329 2.97736 3.64421 22.5456 -43.1143 -6.52899 +9661 4 29.5843 3.84773 3.82541 15.3974 46.6652 11.4603 +9662 4 28.3975 3.01514 3.57252 -35.3193 1.84796 -10.7817 +9663 6 53.9306 32.0952 20.3602 -26.044 3.42844 6.98601 +9664 4 54.8587 32.2554 20.2589 13.6369 -3.90514 -8.57062 +9665 4 53.586 31.7345 19.5218 3.48091 2.50952 8.05406 +9666 6 41.7156 29.5544 6.48768 19.5894 27.0766 -19.1548 +9667 4 40.8143 29.536 6.19581 -21.1406 0.0261655 0.681639 +9668 4 42.121 30.2839 5.93213 -7.9284 -21.0777 21.5612 +9669 6 37.8354 24.5725 39.3073 -0.786614 -2.83003 -8.48557 +9670 4 37.3057 24.1981 38.5867 -0.305281 2.91934 11.1175 +9671 4 37.4479 24.2715 40.1417 -1.64355 1.86967 -5.36783 +9672 6 46.558 27.5785 23.289 -39.9634 -64.6481 11.0379 +9673 4 46.4646 27.3918 24.2576 6.74558 16.0433 -18.2165 +9674 4 45.9199 26.8188 22.9475 37.5572 46.869 6.09964 +9675 6 9.22773 27.2022 8.33468 -36.26 12.7871 28.7267 +9676 4 8.91275 27.6129 9.1801 5.62558 -9.89589 -23.2096 +9677 4 10.1414 27.0456 8.46037 35.2783 -3.07459 2.5747 +9678 6 36.0491 34.1608 13.9867 7.26402 -14.0442 8.68546 +9679 4 35.9913 33.1738 14.0461 -7.39622 22.1346 -4.41017 +9680 4 36.7548 34.3393 13.3524 -0.0889916 -4.95725 -2.25698 +9681 6 51.6742 14.4867 12.321 25.1613 25.5512 -24.4042 +9682 4 52.0989 14.4284 11.4335 -6.19684 -3.38259 22.4379 +9683 4 51.9807 15.3554 12.6493 -12.3863 -19.4348 1.31199 +9684 6 15.2583 19.6409 32.4144 29.0083 -20.2623 -33.8133 +9685 4 15.2558 19.2688 31.4922 3.04968 7.12699 22.6875 +9686 4 14.3622 19.8256 32.5802 -41.1763 4.86179 8.56209 +9687 6 27.6812 24.6569 38.3606 -19.0318 -31.8029 -32.3422 +9688 4 27.9736 25.1472 39.0974 14.6808 26.4307 29.745 +9689 4 28.3717 24.6185 37.6939 9.13491 6.22605 4.36089 +9690 6 37.5205 9.26898 13.6241 11.458 -4.07639 -2.41324 +9691 4 37.986 8.73412 14.2818 -4.17908 -1.66932 4.91722 +9692 4 37.422 10.1332 14.0472 -5.80925 -1.58022 -1.38856 +9693 6 20.8962 33.2419 26.2614 5.37543 12.855 -2.41316 +9694 4 21.3204 33.4412 27.1125 -5.30181 -3.15861 -4.46659 +9695 4 20.9369 32.3076 26.1263 8.87353 -20.0108 1.20924 +9696 6 6.59104 13.9455 35.2329 -26.8274 -4.60486 4.58094 +9697 4 6.38745 12.9897 35.2457 11.7642 5.99643 -3.17645 +9698 4 7.53507 14.0926 35.2395 12.5421 -8.77428 2.26249 +9699 6 10.0726 7.48467 6.8792 2.12641 6.95589 -11.9404 +9700 4 9.21804 7.15917 6.5645 -4.80657 -1.75614 5.47812 +9701 4 10.1222 8.42177 6.5916 5.16955 -15.159 7.51812 +9702 6 31.1977 5.95154 11.4339 24.7603 28.3677 15.6689 +9703 4 31.4296 6.16733 12.4018 -4.97657 -8.97631 -41.3224 +9704 4 31.9131 6.32779 10.8565 -11.9651 -11.6794 24.5691 +9705 6 12.1328 3.85103 35.2933 -10.0815 -12.0493 27.5499 +9706 4 12.7851 4.21657 34.7189 20.4312 8.87509 -12.0205 +9707 4 12.5123 3.89786 36.1903 -2.36263 6.36147 -16.6701 +9708 6 5.35168 6.07805 27.6549 3.96089 -18.0524 46.6648 +9709 4 5.01336 6.85569 28.0965 2.16186 8.49085 15.9688 +9710 4 5.1377 6.25223 26.7855 -7.5711 11.2001 -66.4514 +9711 6 13.1382 33.574 1.68419 20.6109 34.6607 2.95503 +9712 4 12.5953 33.0967 1.0817 -13.6453 -8.09858 -18.4215 +9713 4 13.3822 34.4502 1.26439 -11.0211 -27.5174 16.1165 +9714 6 44.6427 10.3996 29.0359 8.91116 23.4714 -13.18 +9715 4 44.4953 9.45294 29.0952 0.434286 -4.87704 -7.20081 +9716 4 44.1618 10.7755 28.2587 -0.00111917 -13.6507 16.636 +9717 6 9.15295 24.5944 6.37753 4.35763 15.0755 22.3214 +9718 4 8.87327 24.2546 5.53613 0.42871 5.14079 -20.2862 +9719 4 9.64462 25.4438 6.24707 -3.48643 -17.4971 -5.55606 +9720 6 52.5676 27.2719 21.6547 -2.39965 -30.061 -11.5856 +9721 4 52.5233 26.307 21.7841 0.332471 11.3908 13.792 +9722 4 52.7558 27.2791 20.7178 5.02488 16.4903 -8.77251 +9723 6 7.3066 16.9604 33.5537 -1.04195 2.49046 -7.43677 +9724 4 7.33543 17.7138 32.943 1.81348 -0.803559 0.920864 +9725 4 6.38938 16.6816 33.595 -7.62852 -0.129201 -7.36731 +9726 6 43.922 25.2186 7.97522 -0.776236 -10.551 19.3716 +9727 4 43.2647 24.8119 8.58447 10.2741 2.86697 -16.6436 +9728 4 43.4353 25.9147 7.53069 -5.46224 6.25576 -5.43654 +9729 6 2.0869 27.1165 13.6049 -6.62274 17.6596 -9.16822 +9730 4 2.19606 26.2295 13.9488 0.235583 -10.4047 3.43352 +9731 4 2.56841 27.1544 12.7597 2.10867 -4.70259 8.20201 +9732 6 37.3318 18.2771 2.1863 -11.4974 3.81579 3.71073 +9733 4 37.5653 17.6745 1.47223 -1.7687 -9.97531 1.83125 +9734 4 36.746 18.9091 1.7765 -5.93566 5.03593 -3.95155 +9735 6 24.9999 10.057 0.434977 -12.0635 -2.74649 0.799886 +9736 4 24.3308 10.4048 41.7106 3.78591 -9.33137 12.164 +9737 4 24.5954 9.37599 1.02184 5.69483 17.6459 -16.041 +ITEM: TIMESTEP +10 +ITEM: NUMBER OF ATOMS +9737 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 5.4990000000000002e+01 +0.0000000000000000e+00 4.1909999999999997e+01 +0.0000000000000000e+00 4.1909999999999997e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 9.97007 5.59928 0.0158605 6.82717 25.1566 0.173859 +2 2 9.62356 5.56404 40.5109 2.42388 15.8202 -17.9785 +3 2 8.17494 6.05177 40.4142 55.7411 37.9916 -4.02595 +4 3 7.24177 5.30408 40.552 -31.6102 -16.3698 1.50252 +5 4 9.18703 5.26911 0.576869 6.09491 -0.0281501 2.37507 +6 4 10.258 6.55078 0.333037 -13.6694 -25.1619 -9.93433 +7 4 10.7495 5.00053 0.227298 4.73684 -5.2578 1.97242 +8 4 10.3453 6.24708 39.9044 -16.4644 -11.4072 20.4818 +9 2 9.76873 4.13927 39.9675 -11.4588 -40.6165 34.779 +10 2 9.50273 3.78744 38.4932 15.666 28.6261 8.68394 +11 5 10.1133 2.12508 38.0108 0.295651 13.5297 3.11239 +12 2 9.21855 1.10832 39.2168 14.7368 7.58368 -1.20954 +13 4 9.08721 3.4839 40.6484 10.5431 15.7462 -21.5186 +14 4 10.7894 3.80905 40.2705 3.27862 -1.66199 -9.78219 +15 4 9.96352 4.6291 37.9056 6.4614 -19.967 -0.497951 +16 4 8.45197 3.92389 38.2658 -20.9649 -8.28542 -1.62155 +17 4 9.45855 1.42591 40.2577 0.123087 -4.74543 -3.47868 +18 4 9.48787 0.0601841 39.0477 5.23249 -11.9374 1.58081 +19 4 8.1518 1.18086 39.043 -21.148 5.31153 -2.14239 +20 1 8.09229 7.41048 40.3029 -14.2332 10.7223 -5.89196 +21 2 6.79937 8.10304 40.1889 5.24089 -19.8495 27.4218 +22 2 6.18195 7.49232 38.9365 0.114954 6.75236 -38.7125 +23 3 6.7427 7.67352 37.8124 -12.8129 -5.94191 21.2876 +24 4 8.91546 8.03754 40.1502 -4.33809 -15.705 2.93584 +25 4 6.18636 7.83053 41.1247 8.71228 4.86543 -21.2479 +26 2 7.05427 9.64124 40.1755 -39.1485 4.05492 14.7867 +27 2 5.78354 10.5475 40.1236 1.30256 17.7056 10.1762 +28 2 4.88546 10.5193 38.8862 -3.79578 -25.0164 33.8013 +29 3 5.09523 11.2746 37.9701 4.75276 20.2207 -26.2166 +30 1 3.8145 9.69296 38.9578 -10.6259 3.8922 -22.0733 +31 4 7.59986 9.93872 39.279 22.1314 0.316188 -7.87442 +32 4 7.59095 9.90263 41.1476 2.09094 2.02455 -19.3111 +33 4 6.10317 11.6308 40.2015 3.5236 -15.0099 -9.27626 +34 4 5.16114 10.4864 41.0336 -3.30627 -13.4665 3.57605 +35 4 3.54863 9.07856 39.7488 8.69916 3.95403 -0.745788 +36 4 3.18874 9.68238 38.1158 12.5738 1.24403 17.0425 +37 1 5.02604 6.79083 39.0278 7.4524 -0.797845 -45.9123 +38 2 4.17847 6.29332 37.9221 -3.7942 -15.2224 -3.95324 +39 2 2.69747 6.67222 38.2029 32.4064 16.6491 21.8024 +40 3 2.47317 7.27763 39.2627 -13.9875 -5.03172 -5.20453 +41 4 4.49693 6.75941 39.8611 -16.5463 3.77927 46.4214 +42 4 4.45927 6.7815 36.9606 1.68834 7.22657 1.16434 +43 2 4.32357 4.73766 37.6872 -14.444 16.6417 -7.09057 +44 2 3.62009 3.87951 38.7772 14.6644 -34.8859 1.43809 +45 2 5.79989 4.34797 37.5209 14.6689 -37.6664 -23.8861 +46 2 3.73665 2.34984 38.4383 -15.0607 27.3941 -9.62179 +47 4 3.8042 4.58537 36.6865 5.44811 -8.07725 9.84866 +48 4 2.54132 4.09064 38.8487 -7.82462 7.38089 1.0406 +49 4 4.05844 4.00808 39.8052 -1.99007 7.91776 -7.51683 +50 4 6.34139 4.39198 38.494 2.7915 9.59572 -3.8015 +51 4 6.26587 4.94741 36.6895 -0.816692 -0.0793993 15.4171 +52 4 5.96503 3.2496 37.1567 -11.5696 29.092 9.48874 +53 4 3.39623 2.18998 37.357 4.41378 -5.40883 18.8177 +54 4 3.12239 1.76276 39.1489 -5.35757 -4.6989 -2.16583 +55 4 4.76682 2.00075 38.5743 10.6291 -5.64517 -2.52342 +56 1 1.71265 6.3536 37.3575 -33.5913 -12.5481 -9.77554 +57 2 0.284755 6.62158 37.6816 12.6554 33.7668 -4.20076 +58 2 54.3822 5.43344 37.3699 -27.7691 3.87457 8.29319 +59 3 54.7838 4.49252 36.6867 3.01204 -3.04336 -3.37779 +60 4 1.82497 5.72672 36.5372 4.10411 3.68048 5.38879 +61 4 0.194803 6.88576 38.7694 2.48378 -12.979 2.09758 +62 2 54.7189 7.90551 36.9466 -7.72609 -12.13 5.61678 +63 2 0.656639 9.069 36.6919 -2.01357 8.03554 13.9604 +64 2 1.52683 9.2194 35.5966 7.55435 5.75852 -14.6577 +65 2 0.515029 10.1503 37.577 28.0972 23.5099 -14.6501 +66 2 2.25128 10.4257 35.3726 -4.96866 -39.5758 -10.6477 +67 2 1.27413 11.3326 37.3973 2.53894 16.486 1.64204 +68 2 2.1477 11.4375 36.2812 10.2448 65.1187 39.3263 +69 4 53.8018 8.25583 37.5371 13.1335 -2.90056 -11.9634 +70 4 54.3208 7.62968 35.9579 -2.73912 -6.0948 -8.85904 +71 4 1.62786 8.40831 34.848 -1.08621 1.70246 3.68663 +72 4 54.8519 10.113 38.4282 -15.3846 -1.92761 17.9785 +73 4 2.932 10.5406 34.5118 -0.192368 -3.19302 0.526177 +74 4 1.1987 12.2443 38.1226 0.692592 -32.2473 -20.0357 +75 4 2.79857 12.4271 36.2097 -23.9561 -41.0367 -3.09354 +76 1 53.0712 5.5328 37.7893 -5.57771 32.7805 23.2413 +77 2 51.973 4.62909 37.5111 5.69369 -27.8287 -42.174 +78 2 50.7933 5.44178 36.9635 6.83138 2.9595 14.8019 +79 3 50.2601 6.28483 37.7029 -2.00888 -3.43203 -15.9694 +80 4 52.7232 6.34215 38.4237 19.8206 -30.3225 -23.0649 +81 4 52.294 3.8899 36.6472 -5.7065 17.91 27.0613 +82 2 51.558 3.79481 38.7755 -4.51595 7.33433 1.21121 +83 2 50.3828 2.83682 38.5018 -9.13901 -44.4412 -29.5986 +84 2 52.8166 3.00155 39.2294 -15.7012 -7.04664 11.9409 +85 4 51.1774 4.47766 39.5861 12.1653 -0.853429 -2.8896 +86 4 50.5215 2.15128 37.5875 8.57056 17.9281 16.1392 +87 4 49.4053 3.30815 38.2892 0.50336 12.9055 3.57196 +88 4 50.1645 2.10956 39.3273 7.20165 10.7054 2.61524 +89 4 53.3305 3.56036 40.0335 2.85201 1.25263 3.90533 +90 4 53.556 2.88446 38.4204 4.77396 -6.45058 -3.13498 +91 4 52.5519 1.98529 39.6413 5.25091 8.27159 -2.68354 +92 1 50.4114 5.20625 35.6841 -20.1476 8.87025 -3.50293 +93 2 49.1688 5.73971 35.0966 -28.9774 8.99335 -1.66554 +94 2 48.0726 4.67952 35.3573 13.5632 -27.7837 -20.7653 +95 3 48.2724 3.51151 34.9309 -12.9152 20.0019 12.3092 +96 4 50.758 4.377 35.1895 1.67728 -2.63512 -1.50997 +97 4 48.8371 6.69602 35.5973 10.748 -7.18216 5.66994 +98 2 49.2038 6.04752 33.5367 10.0422 21.5226 29.5984 +99 2 47.9776 6.84135 32.9981 5.60977 17.6728 -19.5296 +100 2 48.06 7.31101 31.4919 41.3779 8.51018 8.58065 +101 2 48.2223 6.22581 30.3803 10.2277 10.7815 -8.37061 +102 1 48.1882 6.76889 29.0124 -44.0668 -20.3552 -6.98541 +103 4 49.2392 5.11894 32.9842 10.5057 -23.1259 -12.3022 +104 4 50.1653 6.62923 33.3927 -11.345 -5.02104 -10.4632 +105 4 47.825 7.77207 33.6051 2.48464 -5.23088 2.05035 +106 4 47.0343 6.2773 33.0942 -1.95432 -7.79908 6.21428 +107 4 48.9189 8.07819 31.4105 -13.7973 -19.6161 -0.159439 +108 4 47.1832 7.92091 31.2683 -17.7289 5.61577 -2.96622 +109 4 47.3306 5.536 30.4593 16.0468 -5.76301 1.4082 +110 4 49.2642 5.74618 30.4425 -24.8663 -4.45667 9.08666 +111 4 48.9827 7.28362 28.7526 29.3958 17.558 -6.10605 +112 4 47.3901 7.43056 28.8463 17.4375 -26.0151 1.0329 +113 4 48.1308 5.99149 28.2967 -4.23626 26.2635 18.8845 +114 1 46.923 5.03715 35.9679 -17.5656 23.7329 15.0201 +115 2 45.6707 4.26397 36.0383 7.41887 0.1342 36.2715 +116 2 44.9083 4.3955 34.7419 -9.99807 18.7078 -56.0122 +117 3 45.3082 5.1515 33.8118 -11.5681 -21.3087 27.1246 +118 4 46.8218 5.98238 36.4144 8.23522 -16.4135 -11.8728 +119 4 45.8989 3.17264 36.1884 2.80321 2.94058 -5.13324 +120 2 44.7401 4.70263 37.2808 -1.60464 -36.3649 -20.2774 +121 3 44.4616 6.07663 37.208 27.8602 32.4116 16.0792 +122 2 45.244 4.25605 38.6868 21.6281 49.2853 -20.5016 +123 4 43.7497 4.17807 37.1099 13.0537 7.54308 5.65065 +124 4 45.2592 6.57873 37.5303 -28.9412 -17.1189 -11.5145 +125 4 45.9129 5.11546 39.1089 -19.7485 -23.953 -1.10378 +126 4 45.8752 3.36487 38.6536 3.71139 -12.8851 -1.61893 +127 4 44.3595 4.03827 39.3021 -3.33201 1.23649 16.0156 +128 1 43.7613 3.66416 34.5997 13.2589 -16.0433 44.4251 +129 2 42.7828 3.62815 33.5465 18.9204 -1.21878 -42.6601 +130 2 41.7763 4.78741 33.7016 8.26701 -3.22526 52.4496 +131 3 41.2647 5.35582 32.7525 -2.05798 3.57411 -28.7638 +132 4 43.4932 3.04471 35.4154 4.99312 14.665 -20.8764 +133 4 43.36 3.79542 32.5266 -17.2288 -0.741434 30.8189 +134 2 42.0901 2.2209 33.4572 -3.06831 -30.079 -8.91003 +135 2 42.9343 0.899345 33.7586 6.86735 -2.69949 -8.81151 +136 2 42.2038 41.463 33.3849 1.50493 16.9918 14.9247 +137 2 44.2499 0.864187 32.9361 47.2855 12.5868 41.6398 +138 4 41.5678 2.05281 32.481 6.79941 12.0418 -2.16148 +139 4 41.2531 2.16469 34.1657 -6.29243 10.0771 8.19014 +140 4 43.198 0.869694 34.8519 -1.4112 0.953999 -4.44245 +141 4 42.8702 40.5903 33.6002 -4.10478 0.398246 -9.68788 +142 4 41.7896 41.4589 32.3582 7.27854 -3.68783 -7.38435 +143 4 41.3262 41.3063 34.0224 -6.75638 1.39507 6.42691 +144 4 44.0947 0.829251 31.8728 -5.75954 4.64229 -28.5029 +145 4 44.9396 41.8855 33.1737 -20.9549 12.1515 -1.19165 +146 4 44.9309 1.76601 33.2059 -22.5069 -20.3291 -10.4095 +147 1 41.5145 5.2236 34.9901 10.2672 4.08625 -51.0356 +148 2 40.6676 6.35891 35.268 -24.1778 -10.7223 -7.79527 +149 2 41.3691 7.72376 35.0974 2.95483 13.7574 -3.11119 +150 3 40.6975 8.75349 34.8431 -2.15612 -12.5202 3.44484 +151 4 41.8176 4.64617 35.7553 2.04542 -7.36824 24.1106 +152 4 39.8621 6.3427 34.4551 10.5786 9.41727 7.44594 +153 2 39.8405 6.1283 36.5756 19.8539 -2.67173 26.8296 +154 3 40.7601 5.89106 37.6735 -0.128972 20.3018 -14.678 +155 2 38.9248 4.89402 36.5497 -24.3083 -6.19306 -11.8519 +156 4 39.228 7.01129 36.8511 -0.372961 8.24506 -6.20484 +157 4 41.1549 6.75425 37.8536 -4.13097 -9.7211 -3.01543 +158 4 38.1722 4.94482 35.71 1.05658 9.14576 13.4136 +159 4 38.3953 4.71355 37.5213 -1.28546 9.2328 -6.30902 +160 4 39.3771 3.92967 36.3433 23.1336 -11.0543 -1.24287 +161 1 42.7302 7.8059 35.1562 3.49276 1.34371 4.78693 +162 2 43.5269 8.99303 34.9539 -8.19772 -21.7996 13.9087 +163 2 44.4646 9.39471 36.0778 41.0762 49.5413 -62.5687 +164 3 45.3993 10.2183 35.7654 -29.643 -36.0587 21.7786 +165 4 43.357 7.05719 35.4614 -7.13629 -15.5308 5.06399 +166 4 44.0803 8.92821 34.0189 14.2015 -9.60403 -10.8131 +167 4 42.9032 9.83742 34.7399 -16.6431 23.0824 1.78637 +168 1 44.28 8.95267 37.3076 -5.41717 -6.01048 56.4016 +169 2 45.1954 9.30059 38.3934 14.0544 9.09198 9.45122 +170 2 46.5736 8.71838 38.034 -4.40481 25.0392 4.24124 +171 3 46.7239 7.52665 37.7592 -2.06685 -10.8071 -7.31186 +172 4 43.4369 8.46722 37.66 -0.808029 1.80219 -13.797 +173 4 45.2932 10.4319 38.4595 -5.35026 -12.3633 -15.6489 +174 2 44.7775 8.83735 39.8303 19.1756 -23.9015 -7.23155 +175 2 45.4882 9.63492 40.9425 5.24315 -15.5914 27.8506 +176 2 45.0424 11.1143 41.0465 6.36216 -11.291 -10.339 +177 2 45.9827 11.9035 0.041605 38.3537 -2.96327 34.4916 +178 1 45.5586 13.2421 0.396463 -0.785075 15.3756 28.9492 +179 4 44.9912 7.72238 39.9953 -4.79728 17.8629 -7.78445 +180 4 43.7049 8.96345 39.9422 -22.2512 0.44531 4.07292 +181 4 46.5908 9.56019 40.8161 0.364544 3.82252 -6.52459 +182 4 45.3434 9.10335 0.0599805 -5.24686 13.9981 -23.7842 +183 4 44.0132 11.1324 41.4274 -10.2695 3.39123 6.70816 +184 4 44.9981 11.6023 40.04 1.8072 0.416607 6.15726 +185 4 47.0442 11.9436 41.5493 -17.6115 6.73335 -5.13538 +186 4 46.1824 11.4052 1.05233 -16.0491 -0.928483 -18.7699 +187 4 45.666 13.9003 41.5429 -6.15709 2.25656 -0.794581 +188 4 46.187 13.6261 1.17403 -31.6799 -14.737 -27.4943 +189 4 44.5482 13.2658 0.707841 33.0262 6.71149 -7.77427 +190 1 47.5786 9.61919 37.9975 -0.262725 18.6124 2.96873 +191 2 48.9681 9.33197 37.6414 -20.2336 1.72319 -17.1083 +192 2 49.7588 9.70622 38.88 39.5209 -76.7499 14.8721 +193 3 49.6145 10.763 39.4317 -9.44289 38.5374 13.5639 +194 4 47.4009 10.6083 38.3248 7.77058 -18.5649 -8.96176 +195 4 49.0172 8.23798 37.4216 9.46753 0.884559 0.506936 +196 2 49.3323 10.1282 36.3163 3.6714 0.82331 31.2642 +197 3 48.3563 9.85046 35.3281 -8.1318 -4.77519 -4.71381 +198 2 50.6865 9.72677 35.695 -19.0046 0.743943 -11.7808 +199 4 49.2557 11.2077 36.6021 8.67648 2.0602 -8.11811 +200 4 47.5419 10.2678 35.5977 -2.15846 0.170791 -0.678761 +201 4 50.8563 10.2671 34.7416 2.67544 8.24981 1.47477 +202 4 50.7066 8.66813 35.3754 2.1247 -7.47433 7.78713 +203 4 51.5309 9.954 36.3541 9.43429 -0.352141 7.40173 +204 1 50.5004 8.65755 39.48 -48.513 49.986 -45.0014 +205 2 51.0618 8.74392 40.7907 20.8089 -26.4742 28.5407 +206 2 52.5708 8.35776 40.7906 -32.7343 -31.0986 -30.3541 +207 3 52.9098 7.36002 40.1044 19.6712 31.5314 12.7437 +208 4 50.5882 7.8265 38.898 12.8881 -18.9119 10.2231 +209 4 50.9863 9.78895 41.141 -1.46865 8.60563 4.12328 +210 2 50.3037 7.79505 41.8358 -16.725 28.936 13.8764 +211 2 50.252 6.27959 41.4904 27.2589 15.6434 -4.64867 +212 2 48.8609 8.35011 0.225019 8.85004 14.588 -17.6069 +213 2 49.3953 5.42325 0.497373 -18.8945 7.05888 30.2377 +214 4 50.814 7.95159 0.918621 8.35305 -8.94958 -7.30269 +215 4 51.3186 5.93048 41.4774 -6.84536 -5.23847 5.64953 +216 4 49.9408 6.1608 40.4387 -8.33431 -3.05112 -5.55566 +217 4 48.166 7.96072 41.344 -1.46 7.63128 5.53427 +218 4 48.8165 9.51657 0.246026 0.467008 -30.2893 -0.065267 +219 4 48.5175 7.97406 1.21641 -4.07563 3.27994 -1.48455 +220 4 48.2983 5.58085 0.347667 5.50609 -0.627552 -5.84055 +221 4 49.5344 5.58322 1.60624 7.63779 5.91871 -13.4594 +222 4 49.5909 4.36583 0.361303 3.03099 -20.7712 -9.01704 +223 1 53.3669 9.15083 41.5136 39.5682 14.7354 5.79836 +224 2 54.8443 9.26777 41.6313 -32.7918 27.0996 3.53674 +225 2 0.372396 8.2907 0.722751 15.0567 -33.4937 20.6099 +226 3 54.8856 8.2259 1.87915 11.4238 -3.26125 -20.3466 +227 4 52.9167 9.73978 0.288924 -10.841 14.2188 11.5997 +228 4 0.25416 9.07559 40.636 9.98484 -5.7038 -17.1316 +229 2 0.351513 10.7152 0.19938 0.985642 14.1538 -10.6635 +230 3 54.4575 11.7797 41.7528 -11.3464 -18.6066 -9.73211 +231 2 1.66903 11.1049 41.4122 7.34382 -22.4378 -10.8926 +232 4 0.4803 10.8256 1.29559 2.15483 -15.9854 6.57991 +233 4 54.1789 12.1729 0.660397 -4.76608 7.18995 2.46446 +234 4 2.02372 12.0909 41.706 2.9877 17.6459 6.95349 +235 4 1.57896 11.139 40.2943 0.339955 -2.68366 6.65003 +236 4 2.50746 10.4017 41.6821 -7.50419 3.69742 -2.77337 +237 1 1.45709 7.55056 0.343709 0.783377 10.0466 -6.42735 +238 2 2.26763 6.65075 1.15078 -32.6055 -6.94536 -7.22798 +239 2 3.71498 6.9634 0.985171 49.9575 39.4499 -62.468 +240 3 4.16139 7.41516 41.7733 -24.7374 -20.1855 46.264 +241 4 1.86812 7.64334 41.3079 -3.10568 2.79536 2.39364 +242 4 2.02547 6.77359 2.21072 -7.15361 5.99983 10.1715 +243 2 1.97017 5.19949 0.677115 9.24237 23.8034 -8.70369 +244 2 0.525 4.76245 0.942436 -1.25511 -23.3688 27.6866 +245 2 0.292475 3.39123 0.300736 12.896 -21.1671 11.4366 +246 2 0.300138 4.59931 2.47443 -32.0383 1.7301 9.08136 +247 4 2.70003 4.54767 1.15632 6.2908 -16.3803 10.1517 +248 4 2.22696 5.13751 41.5068 -3.29253 -1.30987 -4.15087 +249 4 54.7656 5.47042 0.590489 -8.39992 14.3218 -15.0438 +250 4 54.2418 3.05018 0.328915 -13.2626 1.11831 3.00682 +251 4 0.884488 2.58096 0.823664 -4.50955 14.351 -5.98985 +252 4 0.593908 3.34298 41.1636 3.48003 3.40906 -16.1017 +253 4 0.952355 3.83641 2.92287 8.67303 -5.41594 2.10418 +254 4 54.195 4.2418 2.71744 29.7111 15.4634 -7.25797 +255 4 0.523461 5.5584 3.03176 -8.55492 -11.4476 -4.98522 +256 1 4.54724 6.69628 2.0028 -11.6083 -5.66543 -5.23244 +257 2 5.9708 6.78048 2.07185 29.6953 24.7002 11.5216 +258 2 6.62679 5.47067 2.57826 -56.9161 -25.5018 -48.7527 +259 3 7.55514 5.44421 3.3345 43.3901 -4.04961 27.9945 +260 4 4.11753 6.29088 2.82459 -1.31884 -6.15538 19.0144 +261 4 6.38329 6.99012 1.0501 -1.44469 -12.2628 1.79191 +262 2 6.4556 7.99651 2.97484 -29.1307 10.2847 -18.0571 +263 2 6.5028 9.34873 2.22705 -18.2939 24.7932 5.04877 +264 2 6.67525 10.5485 3.20576 -19.6949 -28.8822 -17.9407 +265 3 7.83409 10.9407 3.49149 14.4815 4.00472 5.8048 +266 3 5.6204 11.0576 3.67938 3.00737 1.04452 3.25275 +267 4 7.46376 7.72864 3.29072 15.5933 3.84479 14.8832 +268 4 5.82416 8.22265 3.87848 3.62309 -20.6245 -0.107855 +269 4 5.50278 9.55154 1.65377 27.7023 -9.35583 7.15892 +270 4 7.36204 9.37759 1.52673 -1.86837 -2.39822 -10.1271 +271 1 6.01547 4.32119 2.13096 24.825 18.8056 21.8908 +272 2 6.40109 2.94617 2.38906 -11.7575 -20.1643 -12.9237 +273 2 7.81521 2.61654 1.77783 -56.2322 2.45294 33.4207 +274 3 8.31478 3.35811 0.966233 17.239 19.087 -22.9985 +275 4 5.23593 4.40493 1.50032 -13.4301 6.78787 -12.4159 +276 4 6.42741 2.74871 3.48587 6.57798 6.02642 3.28221 +277 2 5.2086 2.00284 1.82478 32.9723 -19.5112 -16.552 +278 2 3.90497 2.10853 2.63909 4.11684 35.775 58.6384 +279 2 4.90372 2.28313 0.318971 -25.0993 -16.9694 6.10511 +280 4 5.56913 0.900136 1.85726 -4.66192 22.2662 6.6067 +281 4 4.03562 1.77943 3.74204 2.08752 -4.13501 -29.3045 +282 4 3.08076 1.58512 2.20328 -21.6762 -25.4002 -11.7361 +283 4 3.47043 3.14079 2.79739 15.5883 -5.24062 -11.8252 +284 4 4.40039 3.24668 0.146776 -5.79992 5.24774 -1.28692 +285 4 4.20501 1.47402 41.8336 8.41255 14.6516 3.66501 +286 4 5.77159 2.28177 41.569 16.6343 -1.64949 -4.80555 +287 1 8.4358 1.54559 2.27475 36.6082 -11.5601 -11.8896 +288 2 9.77403 1.09441 1.8307 -27.8835 12.6882 -14.7267 +289 2 9.60932 41.7912 0.904414 -8.95822 -4.80133 -2.77359 +290 3 8.60977 41.0717 1.04857 16.9017 -0.350054 -8.54673 +291 4 7.96937 0.851078 2.83344 -16.1443 -13.3321 15.6909 +292 4 10.1447 1.96102 1.23179 21.7718 -7.90657 2.9301 +293 2 10.6071 0.627222 3.03652 -0.441548 -3.06629 28.3632 +294 2 11.1182 1.69736 4.03374 -39.6019 -9.33118 23.345 +295 2 12.4276 2.26482 3.60541 40.3504 -3.80329 2.03759 +296 3 13.4833 1.65854 4.00477 -10.9735 16.3163 -6.96273 +297 3 12.4619 3.21875 2.76405 -4.75337 -1.04793 7.93588 +298 4 11.5429 0.117807 2.72279 -4.90068 -9.43781 -6.0473 +299 4 9.98495 41.7532 3.61242 16.0495 13.2539 -10.4034 +300 4 11.2741 1.17979 5.05068 -3.18835 9.28581 -16.8758 +301 4 10.3234 2.48031 4.23808 10.2695 -6.11036 -3.24845 +302 1 10.6563 41.4604 0.0588169 -6.20046 -15.666 -8.24155 +303 2 10.7096 40.1842 41.1911 4.64874 21.5238 9.65168 +304 2 10.6577 38.9638 0.161439 -6.67174 -46.3648 23.9629 +305 3 10.1435 37.8848 41.6696 11.1653 29.5239 15.2576 +306 4 9.85832 40.1011 40.5066 -14.3391 4.69386 -5.52668 +307 2 12.0141 40.2124 40.3653 4.26726 1.71904 -5.44169 +308 2 12.4668 41.6661 40.4777 -1.00635 15.6111 -33.0282 +309 2 11.8673 0.323303 41.767 -12.6506 -21.5702 -15.1443 +310 4 11.8545 39.873 39.2959 0.539662 6.91875 10.5587 +311 4 12.8304 39.5641 40.7546 -3.32338 -3.68521 7.20301 +312 4 12.0951 0.327352 39.5607 -0.26902 -6.73625 15.8499 +313 4 13.5766 41.7696 40.398 -3.05617 -0.547794 6.53436 +314 4 11.6542 1.3898 41.6565 2.06281 16.0871 1.21765 +315 4 12.5433 0.162045 0.691867 15.5992 2.8717 16.0141 +316 1 11.2193 39.0766 1.4086 -4.36655 24.7542 -22.059 +317 2 11.4309 38.0888 2.42328 2.01986 -2.25877 10.0578 +318 2 10.2357 37.7662 3.3374 -3.13249 5.62439 -12.9442 +319 3 10.4243 36.9709 4.25096 -6.41092 -9.96708 1.94465 +320 4 11.5904 40.0068 1.66465 -1.36758 -8.10945 4.45955 +321 4 11.6246 37.1209 1.91909 1.66244 -5.96089 -4.69733 +322 2 12.7089 38.4628 3.26447 -19.7243 1.96837 18.865 +323 3 12.593 39.7548 3.85012 -16.3579 -13.4437 -0.292868 +324 4 13.6002 38.4999 2.63657 13.9756 -7.10852 -11.694 +325 4 12.8962 37.7302 4.10036 -1.36843 4.44789 -10.4248 +326 4 11.9859 39.6657 4.60642 10.4094 13.6351 -5.41979 +327 1 9.02275 38.3618 3.12708 -24.8633 34.0603 -47.8229 +328 2 7.7797 38.1104 3.9237 -5.5143 -4.40103 -12.4219 +329 2 6.80948 37.1627 3.16843 27.134 16.5749 8.61656 +330 3 6.86683 37.0056 1.95165 6.52379 13.0808 -10.3152 +331 4 8.81363 38.9852 2.21874 13.7891 -35.0234 50.9651 +332 4 8.06628 37.5753 4.84119 7.22917 -10.5654 7.4735 +333 2 7.01568 39.4093 4.3407 2.69101 -11.9593 -14.7657 +334 2 7.81876 40.1019 5.42325 -6.79454 3.60365 -28.1432 +335 3 8.28496 41.241 5.20721 -2.75331 10.4655 -0.123769 +336 3 8.08719 39.4782 6.47272 0.652509 -5.2024 22.4807 +337 4 5.97814 39.1687 4.67547 5.82193 1.31451 7.85599 +338 4 6.83632 40.0167 3.42407 6.48365 7.00102 3.75656 +339 1 5.92582 36.4787 3.90047 -14.2639 -13.8348 21.4567 +340 2 4.95916 35.6178 3.24268 -4.4575 6.83929 8.3992 +341 2 3.83929 36.4769 2.71202 -44.4588 -49.3176 -48.5312 +342 3 3.60925 37.6169 3.05258 2.07424 26.7384 14.4764 +343 4 5.8145 36.534 4.942 7.63157 5.21975 -16.3776 +344 4 5.40617 35.1414 2.34351 4.65472 -4.22423 0.555341 +345 2 4.39718 34.509 4.16235 13.2774 -34.7614 9.16528 +346 3 3.98438 35.0519 5.39575 -10.4467 6.31908 32.28 +347 2 5.50619 33.4543 4.48033 -18.4692 -3.54598 29.0115 +348 4 3.53919 33.9402 3.74776 -4.47694 5.79242 -10.2957 +349 4 3.62452 34.3759 6.00064 11.5458 5.5573 -22.0279 +350 4 5.86065 32.9579 3.58801 8.19644 -6.15464 -22.9143 +351 4 5.08151 32.5761 5.12909 16.3877 29.7333 -11.6263 +352 4 6.39565 33.9521 4.95041 -3.85278 -8.84208 3.35803 +353 1 2.97294 35.7888 1.83357 24.6732 25.9217 25.2152 +354 2 1.71267 36.3687 1.37347 -5.03432 -5.896 10.5631 +355 2 0.744229 36.5497 2.58991 -5.24139 24.3125 -23.8477 +356 3 54.9871 37.5497 2.63122 18.6385 -17.0409 3.73872 +357 4 3.28773 34.8825 1.44268 -6.98273 2.93822 -0.272558 +358 4 1.87243 37.434 1.07109 4.86902 -3.5162 -5.74397 +359 2 1.111 35.5523 0.154125 -16.9781 -2.34719 28.1775 +360 2 1.71191 35.9998 40.7076 5.75717 0.931703 -28.4951 +361 2 54.5365 35.7134 0.116808 -8.16561 0.919103 1.38616 +362 2 3.27145 35.9095 40.6267 -43.0781 7.09941 -3.6072 +363 4 1.31237 34.4411 0.36052 2.96229 18.9121 -10.1464 +364 4 1.38444 37.0145 40.3207 4.07875 -5.77915 19.4423 +365 4 1.27316 35.3433 39.9124 8.37762 -5.40948 6.65521 +366 4 54.0772 35.0942 41.2103 3.74338 3.48587 4.89864 +367 4 54.2123 36.7722 41.8688 5.5832 -2.69651 -3.34762 +368 4 54.0157 35.4055 1.08169 10.5414 -0.491815 -14.4897 +369 4 3.61367 34.902 40.8802 7.83264 -12.2373 1.45006 +370 4 3.69229 36.6315 41.3343 12.2091 5.94613 6.19684 +371 4 3.59275 36.1798 39.604 6.95495 -3.49191 -4.00644 +372 1 0.74604 35.6172 3.54454 -3.3388 -35.9018 49.598 +373 2 0.0112331 35.6552 4.85892 21.257 7.22823 -39.6883 +374 2 0.198256 37.0471 5.48367 -2.86302 -31.8341 -17.2866 +375 3 54.1912 37.6952 5.75353 -1.48181 26.0574 3.92406 +376 4 1.16676 34.6739 3.4098 -0.571923 12.3969 -9.16993 +377 4 53.9399 35.5324 4.59955 -13.6683 1.62606 4.36563 +378 2 0.479844 34.4894 5.77304 -8.63544 -0.437888 22.4632 +379 2 54.7769 34.3327 7.14546 -8.87326 -9.27459 2.92058 +380 2 0.0146857 35.4787 8.12524 6.60033 -5.57439 2.5368 +381 3 54.0952 36.3427 8.3329 8.35004 -1.43527 5.86114 +382 3 1.11008 35.478 8.75909 4.47833 6.11486 1.03148 +383 4 1.57132 34.5563 5.98457 -0.698959 1.91632 -4.64924 +384 4 0.309529 33.5134 5.28188 2.4365 -3.54209 -11.468 +385 4 0.179249 33.4003 7.64738 0.479338 5.67065 -5.66203 +386 4 53.6776 34.105 7.04833 9.83525 6.91672 -4.06122 +387 1 1.48459 37.3964 5.63734 26.9411 18.0032 -4.38534 +388 2 2.00708 38.6625 6.18614 -17.3218 -26.0277 -29.9987 +389 2 1.56827 39.8885 5.33406 1.07082 -15.6319 68.2882 +390 3 1.08143 40.8395 5.94485 1.04665 3.34176 -10.6171 +391 4 2.21263 36.6994 5.39095 -3.57075 5.04293 0.958686 +392 4 1.48422 38.7142 7.17744 15.2971 12.5748 0.959573 +393 2 3.55969 38.5843 6.25222 7.32448 -15.8569 15.0135 +394 2 4.09689 39.7132 7.09894 -5.63198 1.92213 9.01267 +395 3 4.56636 40.7179 6.56654 0.030916 3.04529 -1.1693 +396 1 3.96361 39.556 8.43894 1.042 12.9555 16.4237 +397 4 4.05831 38.7157 5.24953 -10.2579 -5.90723 4.64011 +398 4 3.91694 37.5778 6.70114 -5.07122 23.1073 -10.2752 +399 4 3.40266 38.7698 8.86734 10.6722 14.2638 -7.23316 +400 4 4.31989 40.3411 9.06061 -10.7144 -22.9188 -14.0526 +401 1 1.60475 39.819 4.02334 -43.55 39.5967 -43.6917 +402 2 0.959151 40.8062 3.12947 9.93922 10.0651 20.657 +403 2 54.4776 41.0208 3.48285 -52.4492 -13.4217 15.5726 +404 3 53.9715 0.237442 3.65017 19.1527 -10.2385 2.60078 +405 4 2.04263 39.1125 3.49268 25.4866 -43.7222 -11.6271 +406 4 1.43469 41.7946 3.36052 -1.16639 -0.650149 -3.04645 +407 2 1.13376 40.5205 1.61049 -4.45578 -2.70165 -27.9407 +408 2 0.490261 41.6149 0.695896 4.53105 0.20202 29.6943 +409 2 2.64975 40.4484 1.23692 -3.92583 -1.39436 -18.6979 +410 4 0.60342 39.5705 1.32385 8.41785 -1.89228 7.96418 +411 4 54.3692 41.6195 0.82936 4.25856 9.6792 3.81375 +412 4 0.622371 41.4492 41.5424 7.52435 -6.48816 -19.7965 +413 4 0.973053 0.688907 0.936332 -12.1275 -4.49455 -2.44597 +414 4 2.86969 40.4983 0.122209 -12.9804 -12.5133 18.6513 +415 4 3.14027 39.5547 1.69882 2.20392 3.04031 -6.93039 +416 4 3.17994 41.3387 1.56797 8.55742 10.8937 16.8775 +417 1 53.6665 39.902 3.64569 3.02926 35.878 11.6697 +418 2 52.2466 39.9148 4.06102 19.2385 27.0707 -26.8098 +419 2 52.053 40.5369 5.44904 5.36155 -11.3244 -6.70427 +420 3 51.0493 41.2119 5.6977 3.00195 1.8183 -1.23959 +421 4 54.0359 38.9941 3.4462 12.1828 -26.316 -3.91411 +422 4 51.7731 40.6655 3.34079 -4.82064 -14.7659 11.8755 +423 2 51.582 38.5149 3.95778 -5.61462 -20.1546 -9.91009 +424 2 51.4355 37.9559 2.49174 21.0062 -12.2216 22.8132 +425 2 51.0144 36.4629 2.37849 -12.7289 -13.0945 -11.3158 +426 2 50.8009 35.9817 0.883468 22.3055 45.8074 13.5352 +427 1 50.1864 34.6873 0.684667 2.36531 28.1154 -10.556 +428 4 50.5344 38.5648 4.38466 13.3699 -2.49694 2.21203 +429 4 52.2198 37.7725 4.53757 -13.8611 9.51826 -2.20414 +430 4 52.4594 37.9738 2.01537 -10.7122 14.3169 -4.94324 +431 4 50.6781 38.6054 2.01085 7.27079 0.282464 -15.5314 +432 4 50.0599 36.3043 2.92579 -2.19776 -0.350037 2.41174 +433 4 51.7586 35.7685 2.83822 0.223715 4.6579 4.31096 +434 4 51.8274 35.9658 0.402852 -15.0801 -2.53131 0.358002 +435 4 50.2142 36.8299 0.38331 4.02889 -26.7998 -2.47013 +436 4 50.6312 33.9821 1.2741 -7.74727 -6.99272 -14.4028 +437 4 50.1255 34.5169 41.5875 17.6482 -15.4813 7.31014 +438 4 49.2229 34.7469 0.909632 -22.6621 -5.40937 19.0501 +439 1 53.014 40.2496 6.3528 -7.33511 22.7823 24.6419 +440 2 53.0995 40.7279 7.73814 -49.8191 -29.044 -3.24915 +441 2 53.1557 0.329785 7.7965 36.8238 12.814 -39.8954 +442 3 52.5287 0.997511 8.60414 -15.9304 4.02299 13.5617 +443 4 53.7341 39.5741 6.15629 12.7417 -17.108 -13.0125 +444 4 52.0658 40.401 8.2322 35.0205 13.5384 -7.46142 +445 2 54.2887 40.0362 8.44194 -31.1952 -6.28028 37.9979 +446 4 54.3393 40.3597 9.51814 11.9598 15.0179 -15.3163 +447 4 0.207826 40.1934 7.85611 17.4499 5.7482 6.56468 +448 4 54.1321 38.9464 8.61757 0.233079 -2.0185 -17.8759 +449 1 53.9798 0.938968 6.8679 -0.195991 -19.5991 -5.8991 +450 2 54.0539 2.3703 6.69095 -13.0728 33.3033 12.6105 +451 2 52.7411 3.03405 6.19669 -13.7918 -57.342 -43.9621 +452 3 52.3429 4.1409 6.51048 0.805927 21.8583 24.6591 +453 4 54.6966 0.402301 6.30051 -22.9471 7.504 14.9388 +454 4 54.1387 2.85352 7.70963 6.90446 -7.48262 -5.16091 +455 2 0.230181 2.82991 5.77971 -8.39605 37.5401 -18.7849 +456 2 1.62806 2.36187 6.13631 43.8101 -17.859 13.5365 +457 2 2.01439 2.63812 7.6434 4.44409 -15.8917 -34.667 +458 2 3.251 1.82053 8.03886 10.3698 -25.435 21.3536 +459 1 3.78609 2.13458 9.37971 -1.03569 -21.7613 -70.4054 +460 4 0.236987 4.00662 5.72725 -0.841737 -32.3075 1.88093 +461 4 55.0233 2.47547 4.72977 -1.92078 4.0191 4.58104 +462 4 2.43886 2.84427 5.52141 -13.7997 6.98566 -1.14785 +463 4 1.8001 1.26942 5.8525 -13.1218 12.7308 11.199 +464 4 1.17734 2.2629 8.25415 -4.76662 9.03037 15.6753 +465 4 2.26439 3.72233 7.77766 -11.2971 -1.006 3.39024 +466 4 4.0605 1.91272 7.29579 6.96563 5.43042 -1.59904 +467 4 3.03028 0.709673 8.06144 -4.99399 12.6268 -3.20223 +468 4 3.89697 1.2978 9.90866 2.2165 -13.9672 17.3419 +469 4 3.11983 2.70535 9.83652 -2.18207 25.7622 26.4666 +470 4 4.71792 2.51816 9.23842 -3.78155 13.4581 18.6473 +471 1 52.0021 2.30339 5.27929 12.8772 20.7449 44.6796 +472 2 50.6928 2.72834 4.84618 -13.8318 -0.832969 -24.58 +473 2 49.579 2.58092 5.91693 0.565718 25.7533 -2.22664 +474 3 48.7752 3.51298 6.10069 9.60089 -13.9081 0.0850852 +475 4 52.4111 1.47967 4.84803 3.54375 -13.752 -6.04623 +476 4 50.7183 3.81521 4.5849 2.62435 0.742467 8.46338 +477 2 50.3339 2.0499 3.47904 12.4361 -26.7668 8.24264 +478 2 51.3981 2.34325 2.36407 -25.9391 22.844 -14.5031 +479 2 48.9153 2.37958 2.98651 -2.89914 40.9383 9.35249 +480 2 51.1891 1.41918 1.15407 38.5806 -15.4927 -30.3188 +481 4 50.4158 0.92469 3.65006 -8.90797 13.02 4.48026 +482 4 52.4055 2.20648 2.74929 18.7984 -5.45377 5.09466 +483 4 51.3666 3.42411 2.00589 -1.76359 -13.5005 7.53435 +484 4 48.1353 2.36077 3.79579 2.75746 -16.6411 -10.078 +485 4 48.6799 1.76326 2.11438 -14.9792 -11.0957 -5.84075 +486 4 48.8325 3.45193 2.63807 7.50371 -11.7896 -0.401559 +487 4 52.1004 1.43799 0.414216 -21.3416 1.39174 26.2203 +488 4 50.3409 1.68288 0.503068 -10.2032 3.93981 2.99084 +489 4 51.0565 0.33979 1.46483 1.72575 11.8892 -3.22767 +490 1 49.5807 1.53255 6.75244 19.5889 -24.3514 7.76629 +491 2 48.7262 1.39688 7.92951 3.12598 20.2674 -1.73108 +492 2 48.8873 2.63773 8.86406 -22.8968 -16.6402 -5.42224 +493 3 47.8891 3.05472 9.45614 -0.472007 6.27789 -5.95623 +494 4 50.2352 0.731103 6.58688 -10.8709 15.7502 1.66713 +495 4 47.6402 1.39986 7.60999 11.2933 -0.131061 -1.07735 +496 2 49.0614 0.0990051 8.70607 -29.9824 -25.1823 -11.7347 +497 2 48.2869 41.7602 10.01 13.4599 -0.122667 29.7563 +498 2 46.7828 0.0292377 10.0132 -0.929007 -24.4408 -23.1824 +499 3 46.2118 0.52149 10.9702 -12.9016 15.2185 13.9881 +500 1 46.1401 41.3429 8.96595 27.5879 22.2376 34.4467 +501 4 50.107 0.108866 8.97457 27.7162 -1.73681 3.74735 +502 4 48.8999 41.0818 8.03917 5.36927 20.2302 10.0129 +503 4 48.7183 0.460982 10.852 -8.35522 8.57003 -12.646 +504 4 48.4869 40.755 10.454 -1.65554 -4.90235 -14.5783 +505 4 46.6392 40.8985 8.22302 16.4703 -11.2583 -22.7525 +506 4 45.1487 41.2958 8.97726 -40.9601 -1.33251 0.190018 +507 1 50.0995 3.17318 9.05078 3.95851 -0.0485648 -3.79593 +508 2 50.3325 4.25644 9.97415 17.5873 21.0859 -2.62556 +509 2 49.9752 5.63804 9.37548 -18.0954 -29.5198 29.938 +510 3 49.379 6.45094 10.0988 9.73071 -4.74536 -2.58342 +511 4 50.9107 2.76055 8.59957 11.9693 -5.38147 -4.75744 +512 4 49.6509 4.09994 10.8399 -6.9467 2.38538 1.23714 +513 2 51.7744 4.26209 10.561 -12.6039 -21.2869 -0.279481 +514 2 51.8614 5.17465 11.7883 77.4573 -1.34868 -55.222 +515 3 50.9415 5.19238 12.5756 -62.6641 4.37367 45.7089 +516 3 52.9385 5.83334 11.9521 -15.5069 -3.45829 -0.856418 +517 4 52.5513 4.49045 9.80335 -1.41111 7.91559 -3.33271 +518 4 51.9847 3.17606 10.8252 3.56611 15.7947 8.37571 +519 1 50.1134 5.83384 8.05697 5.03044 -3.38183 -24.9476 +520 2 49.6949 7.07302 7.45907 -6.39224 21.6045 -14.6025 +521 2 48.2404 7.19765 6.96855 9.41443 -40.5535 -11.5325 +522 3 47.5994 8.23003 7.09737 -2.60339 17.4007 5.13595 +523 4 50.5903 5.18529 7.39903 -4.72806 0.48988 13.3104 +524 4 49.6568 7.79446 8.28532 6.84483 14.8177 6.93296 +525 2 50.7045 7.63108 6.39006 -19.8247 -9.47824 8.02755 +526 2 50.6996 6.84785 5.08902 -10.629 2.31661 -15.1243 +527 2 51.6586 7.26626 3.9659 -11.3496 43.5825 3.95364 +528 2 53.1317 7.00105 4.2557 32.8208 18.7244 -18.8206 +529 1 53.7683 7.95578 5.14747 -10.6729 7.59108 -11.9454 +530 4 51.7028 7.64661 6.81348 16.7201 -1.45014 11.0251 +531 4 50.4708 8.68128 6.19684 -5.34256 14.1207 -5.41714 +532 4 49.6713 6.8702 4.6668 -0.861277 1.74329 -1.61352 +533 4 50.8688 5.79892 5.31654 5.28855 -19.0543 2.54637 +534 4 51.4741 8.35024 3.65396 8.42695 -12.5098 16.2485 +535 4 51.3565 6.79125 3.04708 -1.5826 -26.0582 -19.3792 +536 4 53.7673 7.0998 3.31183 -20.6632 -9.77681 9.39502 +537 4 53.2972 5.98514 4.64126 3.7215 -8.75629 2.11801 +538 4 53.3251 8.87081 5.17658 4.71004 0.103302 -2.74719 +539 4 54.7439 8.12131 4.95956 10.0262 2.1061 -7.58392 +540 4 53.7752 7.60869 6.06781 -3.05466 -8.65204 35.212 +541 1 47.7159 6.1092 6.3306 31.3529 14.3598 14.0351 +542 2 46.4076 6.11425 5.7591 -25.7668 -19.0326 -13.8071 +543 2 45.4013 5.23171 6.47844 56.1675 -11.9112 16.6864 +544 3 44.23 5.34684 6.24133 -49.2229 2.39302 -4.99484 +545 4 48.3398 5.28969 6.15889 -17.2258 10.451 -1.21207 +546 4 45.9358 7.11624 5.83656 4.3919 7.44058 4.79016 +547 2 46.401 5.6982 4.25555 12.45 -16.5042 -24.1702 +548 2 46.8608 6.82251 3.28226 -4.83626 -15.1342 -13.4955 +549 2 46.0803 8.13881 3.30599 -14.5444 -4.79224 -13.1752 +550 3 44.9716 8.27119 2.67975 10.7775 -8.64163 7.28309 +551 3 46.5691 9.08454 3.95876 4.86602 16.815 8.62941 +552 4 45.3845 5.39013 3.90204 -1.72737 6.76951 8.44594 +553 4 47.0179 4.72632 4.06618 -9.2699 26.8442 8.77601 +554 4 46.8747 6.40942 2.20799 2.04532 8.89503 18.2744 +555 4 47.9008 7.08537 3.56457 7.18737 -1.18981 -5.53646 +556 1 45.8799 4.29222 7.33829 -37.7514 2.20406 -4.61566 +557 2 44.9987 3.41141 8.06424 -3.99299 1.7641 -5.76947 +558 2 44.3276 2.33248 7.21969 -45.1266 -42.7281 27.6017 +559 3 43.411 1.613 7.73718 25.6836 24.6852 -13.962 +560 4 46.8488 4.10168 7.49502 31.0353 -1.43619 1.82022 +561 4 45.5349 2.87862 8.87403 3.80662 2.65181 2.49747 +562 4 44.2009 4.01738 8.56522 2.51171 -3.43938 -1.53795 +563 1 44.7359 2.05713 5.97006 1.92732 3.23614 21.462 +564 2 44.1948 0.978467 5.13766 -26.7101 17.135 -13.9432 +565 2 44.8486 41.5478 5.5025 3.41127 -20.6454 16.5554 +566 3 46.0871 41.4431 5.57675 -14.0525 11.0231 2.35631 +567 4 45.5581 2.59183 5.73006 15.6975 -3.64086 -27.3416 +568 4 43.0338 0.980574 5.28193 28.569 -9.56263 1.83686 +569 2 44.4255 1.37435 3.62453 6.02041 -5.1027 -4.41971 +570 2 43.5303 2.62118 3.29791 4.64703 16.7196 -23.7169 +571 2 44.2051 0.148173 2.67978 -29.1583 2.83252 11.5038 +572 2 43.5747 3.10962 1.83395 1.21002 2.08355 -6.515 +573 4 45.4937 1.66977 3.44724 -0.165314 0.952935 9.41179 +574 4 43.8006 3.52551 3.92139 -2.56937 -12.5949 1.07415 +575 4 42.4611 2.43664 3.46298 -10.2855 -9.14552 12.9963 +576 4 44.5119 0.377143 1.64896 8.27723 -0.881131 -7.54742 +577 4 43.1044 41.7625 2.59144 16.8524 3.81389 6.96191 +578 4 44.7846 41.171 3.05101 -3.46686 1.83863 -12.0461 +579 4 44.5392 3.56167 1.57116 9.55733 8.13116 4.62467 +580 4 42.7809 3.86627 1.57982 6.14378 -4.69974 7.81616 +581 4 43.4757 2.31615 1.08375 -8.22918 -11.6964 -1.57482 +582 1 44.0839 40.4233 5.76821 21.932 -1.5334 -8.86254 +583 2 44.7424 39.1674 6.24443 -3.28027 29.5462 -2.23354 +584 2 45.6232 38.4648 5.15467 16.5957 -3.17533 31.1682 +585 3 45.1655 38.1269 4.0769 -9.06079 2.14789 -9.97198 +586 4 45.3594 39.5074 7.13461 -7.15079 -15.4686 -7.49065 +587 2 43.5266 38.3049 6.70081 12.2837 2.36218 -7.01546 +588 2 42.3912 38.8204 5.83129 -5.25874 0.19697 14.2242 +589 2 42.6515 40.3318 5.90174 -25.8883 17.7161 37.6601 +590 4 43.2615 38.5482 7.76954 6.63706 -13.879 -3.94164 +591 4 43.7406 37.2122 6.50504 -6.24398 7.50926 12.4246 +592 4 41.3856 38.4747 6.1895 5.24712 7.09666 -1.13826 +593 4 42.5101 38.4102 4.83081 -0.0162975 -1.57753 -20.806 +594 4 42.2783 40.7857 6.94925 18.7272 -16.9878 -38.5107 +595 4 42.0764 40.8825 5.13323 2.00122 -0.967094 -8.03005 +596 1 46.8623 38.0021 5.57674 -15.3549 -23.0767 -9.82664 +597 2 47.7161 37.0187 4.84527 -3.88045 42.2808 23.2471 +598 2 47.0384 35.8723 4.15029 10.1677 -9.37304 -39.3599 +599 3 47.4551 35.4743 3.0324 -9.4669 19.846 29.5852 +600 4 48.2252 37.6386 4.0698 7.54977 -11.2433 -2.33648 +601 2 48.6452 36.5035 5.99482 -10.0312 13.1223 -5.95218 +602 2 48.8959 37.7819 6.80046 -4.41071 -5.72741 24.5975 +603 2 47.4918 38.4151 6.80561 23.284 1.3706 -4.72721 +604 4 49.5844 36.0861 5.59811 5.91725 -9.04521 -0.913385 +605 4 48.1158 35.748 6.64071 6.83063 -0.71303 -5.46675 +606 4 49.6383 38.4449 6.34864 7.02588 7.83512 -10.7506 +607 4 49.3019 37.5753 7.85532 -11.9914 1.76609 -18.7023 +608 4 47.544 39.5162 6.85821 3.72706 6.34433 1.60956 +609 4 46.9486 38.0654 7.68542 -11.5693 -5.06488 12.3189 +610 1 46.0019 35.318 4.78064 -26.4221 -3.88232 27.7903 +611 2 45.3025 34.13 4.26579 26.8092 19.3149 11.5505 +612 2 44.4585 34.46 3.02929 16.6723 1.23881 35.6677 +613 3 44.3932 33.6565 2.12406 -6.96945 -13.3218 -23.6344 +614 4 45.6895 35.6839 5.72645 6.17072 -11.3773 -21.4598 +615 4 46.1371 33.4525 3.9443 -9.57056 -4.48549 -9.01935 +616 2 44.5851 33.4333 5.41517 7.28023 -34.3989 -9.31284 +617 2 43.896 32.1478 4.95943 -2.5072 53.7563 23.2534 +618 3 42.6929 32.0377 5.28407 -11.6877 -17.8688 -5.68187 +619 3 44.6212 31.2997 4.42805 15.8429 -32.9345 -13.4225 +620 4 43.8908 34.1037 5.87793 -28.8167 18.0933 10.1447 +621 4 45.2673 33.1449 6.25678 1.67129 3.14432 -6.05002 +622 1 43.9425 35.6996 2.93756 -0.354949 -32.7532 -51.8723 +623 2 43.3733 36.2033 1.70184 -38.6892 -13.1006 14.7431 +624 2 44.3694 36.8017 0.73913 15.0439 4.82349 -39.1461 +625 3 44.0609 36.9601 41.4463 -0.757384 -5.0254 19.6545 +626 4 44.0082 36.3398 3.67638 4.88567 37.3717 42.7902 +627 4 42.8639 35.3314 1.17484 15.8753 7.76257 0.915116 +628 2 42.1931 37.1947 1.98861 35.687 20.598 -23.7763 +629 2 41.116 36.6037 2.88066 -6.28281 10.7168 27.7809 +630 2 39.8788 37.4748 2.97821 -20.6793 -12.2331 -39.8799 +631 3 39.5744 38.0012 4.02693 -4.5695 14.1805 28.3661 +632 1 39.0796 37.534 1.86047 23.989 -9.69865 9.57867 +633 4 41.7899 37.5369 1.00167 -6.59533 -6.76427 4.06671 +634 4 42.6371 38.1477 2.39011 -7.96796 -7.2267 7.32793 +635 4 41.4745 36.4913 3.95075 -0.75248 -0.913082 -13.6466 +636 4 40.7949 35.61 2.55083 -3.16107 -12.1939 -5.02302 +637 4 39.3636 37.1043 0.951835 -4.89499 3.13933 11.6446 +638 4 38.1602 37.9899 1.92801 1.07188 2.17452 -2.18356 +639 1 45.5977 37.1878 1.1702 -15.0402 3.91697 -26.2999 +640 2 46.6124 37.7593 0.269692 0.961344 -25.1749 -6.20454 +641 2 47.1251 36.6298 41.227 -15.6894 27.1972 18.7996 +642 3 47.6617 35.6605 41.7393 11.2436 -21.3221 -9.23089 +643 4 45.7953 37.0706 2.14421 15.4189 2.49224 25.3654 +644 4 46.1246 38.4981 41.5406 -7.74237 14.7139 -7.84953 +645 2 47.8075 38.4099 1.03092 10.1012 15.6193 -18.1996 +646 2 47.4246 39.6903 1.82563 -12.4684 -22.6418 23.6998 +647 2 48.6005 40.4099 2.51691 -17.3417 -7.9082 6.23218 +648 3 49.6876 40.5582 1.97833 4.99301 -0.872474 -9.60266 +649 1 48.339 40.8761 3.75079 34.2245 13.1834 24.2049 +650 4 48.6123 38.7237 0.293834 -9.9427 -4.45455 6.13719 +651 4 48.2879 37.6501 1.66455 2.7768 -3.8165 9.90104 +652 4 46.6323 39.34 2.60232 21.0344 18.1725 -15.5096 +653 4 46.9544 40.4315 1.1644 -6.65764 6.44375 -5.56957 +654 4 47.4103 40.9551 4.17425 -6.86232 -2.61251 -1.04516 +655 4 49.1568 41.2536 4.3255 -23.3959 -10.5461 -18.532 +656 1 47.0132 36.8194 39.8944 4.79393 -10.5252 -5.84263 +657 2 47.6604 36.043 38.8342 19.1375 -30.0942 8.85154 +658 2 48.4687 37.0132 37.9763 6.82075 18.1877 -22.3602 +659 3 47.9595 37.6039 37.0009 8.77071 -9.81154 18.2462 +660 4 46.405 37.5569 39.5258 -2.34297 5.9549 -2.23138 +661 4 48.4229 35.2731 39.2798 -19.3933 25.0679 -4.92238 +662 2 46.6775 35.1997 37.9517 0.490197 24.678 -10.7229 +663 2 46.0672 34.0096 38.7198 -38.9175 -0.700818 10.3629 +664 2 46.8744 32.685 38.9073 -3.26917 9.79703 -36.9848 +665 1 47.7628 32.6295 40.0786 -15.9706 28.2316 14.6984 +666 2 48.51 31.5331 40.3435 -4.63001 14.745 41.8738 +667 1 48.7312 30.5422 39.5064 -7.34995 -4.23697 -9.55446 +668 1 48.9018 31.3819 41.635 -19.9532 28.2508 -37.0556 +669 4 47.1729 34.8887 37.0027 6.80802 -10.5296 7.48075 +670 4 45.9076 35.9114 37.5121 1.10402 -9.8189 16.5264 +671 4 45.0997 33.7597 38.1755 17.1722 -3.36537 -3.11703 +672 4 45.6001 34.3514 39.6854 13.8349 -0.884929 -1.62484 +673 4 47.4022 32.4647 37.9216 2.87405 7.70981 18.3952 +674 4 46.1271 31.862 38.9206 0.553217 -4.0431 12.8995 +675 4 47.6279 33.4362 40.8042 9.43822 -37.2826 -24.9694 +676 4 48.3342 30.5657 38.5603 0.826291 -3.97588 -2.82687 +677 4 49.185 29.675 39.7859 6.04467 -9.07236 4.91997 +678 4 48.5432 32.0104 0.443983 -2.47374 7.53927 7.97734 +679 4 49.3442 30.5519 41.958 17.8055 -32.7958 11.0172 +680 1 49.7507 37.2761 38.36 -27.9891 3.94923 -10.3626 +681 2 50.6372 38.1716 37.6465 6.90802 9.01894 -16.7299 +682 2 51.1009 37.4739 36.3314 6.00851 -0.000986305 0.302592 +683 3 51.4496 36.2941 36.3505 -3.04594 -4.29189 2.8804 +684 4 50.1774 36.6397 39.0138 14.1864 -12.0724 14.4781 +685 4 50.0595 39.0583 37.2837 -1.51256 1.6517 8.14679 +686 2 51.8464 38.6091 38.5553 2.49074 0.426256 -22.3009 +687 2 51.5192 39.49 39.8069 -13.5557 -5.73698 -8.16935 +688 2 52.7888 39.6608 40.6664 -21 22.821 44.9745 +689 2 51.0354 40.8913 39.3667 -19.684 19.0705 -14.0846 +690 4 52.5817 39.1556 37.8894 -7.88883 -2.40182 8.97054 +691 4 52.3725 37.6699 38.8321 2.26719 1.04002 8.03718 +692 4 50.6848 39.0041 40.3963 9.50705 2.70236 -0.692257 +693 4 52.9505 38.8088 41.3668 0.716139 -3.31122 -6.89789 +694 4 52.7117 40.5855 41.3722 -1.5977 -23.2904 -18.3054 +695 4 53.6872 39.819 40.0903 21.6097 1.4026 -14.7648 +696 4 51.7777 41.4333 38.7338 5.73144 0.910017 10.7761 +697 4 50.6933 41.5309 40.2327 12.7628 -5.43827 -4.45399 +698 4 50.1361 40.9136 38.7005 3.06807 -14.6998 5.44273 +699 1 51.1637 38.2069 35.1833 -8.65277 46.2898 44.1617 +700 2 51.553 37.7419 33.8846 1.56046 15.8517 -26.9219 +701 2 52.7972 38.5563 33.3946 6.24297 -42.3048 -4.64985 +702 3 52.8896 39.7642 33.5814 -6.435 17.9384 2.35192 +703 4 50.9569 39.2647 35.262 8.21378 -41.2603 -12.3383 +704 4 51.8027 36.6701 33.8819 4.46523 -10.0245 6.73196 +705 2 50.2986 37.9511 32.9329 -9.17145 -5.64023 18.3882 +706 2 49.0629 37.0889 33.4059 8.5101 -2.50878 -15.0431 +707 2 50.6601 37.6697 31.4816 -9.00198 -6.28682 -34.5666 +708 2 49.2037 35.5513 33.2317 13.0867 -6.63955 11.9256 +709 4 49.9372 39.0006 33.0238 8.27291 6.69816 -3.39278 +710 4 48.1686 37.4323 32.8001 8.11156 -5.69031 9.58675 +711 4 48.8477 37.3684 34.464 -5.28515 -5.82898 -0.156702 +712 4 49.7508 37.5287 30.8047 12.011 -0.0430796 16.0089 +713 4 51.2928 36.7446 31.376 -4.11156 8.47591 0.32382 +714 4 51.1768 38.5507 31.0175 4.51478 -6.96789 5.36543 +715 4 50.1453 35.1216 33.7014 -11.0082 12.206 -5.4516 +716 4 49.2178 35.23 32.1578 -3.59036 3.22922 4.55632 +717 4 48.3665 35.0295 33.7638 0.68062 2.42879 -7.65558 +718 1 53.772 37.8505 32.7005 11.9802 38.3584 -9.99311 +719 2 54.8892 38.4918 31.9453 -18.9337 33.3604 36.4373 +720 2 0.0457823 37.9282 30.5422 -8.24024 2.92716 -24.5162 +721 3 0.594264 36.8423 30.3259 -11.3073 1.50903 5.31397 +722 4 53.7906 36.8495 32.616 -6.44893 -30.0966 2.1434 +723 4 54.5933 39.6185 31.9763 4.67753 -27.1194 -20.6963 +724 2 1.30394 38.4484 32.6241 4.82921 -5.73508 14.5601 +725 2 2.2605 39.423 31.9346 -38.1373 19.2777 23.8899 +726 2 1.83713 40.7771 31.9484 17.1926 2.24265 -1.86924 +727 2 3.4991 39.1266 31.4137 44.2785 -3.28979 -22.8275 +728 2 2.64242 41.8019 31.4282 -29.5168 1.86603 13.0701 +729 2 4.3212 40.1796 30.8558 3.27898 -39.2743 8.81887 +730 2 3.87185 41.4777 30.8782 6.24363 43.3598 -8.15054 +731 4 1.73925 37.4095 32.5315 -6.00214 7.91305 5.68876 +732 4 1.22265 38.7505 33.7444 5.52003 -9.57077 -28.715 +733 4 0.900292 41.0813 32.4345 -2.25415 1.01323 1.36593 +734 4 3.85804 38.0586 31.4239 -1.87041 17.6471 -1.97414 +735 4 2.21075 0.929728 31.5263 16.6224 -11.4708 -8.14622 +736 4 5.34427 40.0148 30.4252 -14.7168 -7.47964 5.81345 +737 4 4.49601 0.410438 30.4759 -4.95559 -13.7664 3.94973 +738 1 54.5157 38.6773 29.5249 -27.0888 35.6462 7.20647 +739 2 54.4663 38.361 28.1069 5.2815 -2.56059 -27.0064 +740 2 53.8105 37.007 27.8285 4.1142 -30.4598 -15.4676 +741 3 54.2925 36.1623 27.0158 -8.84 24.3654 24.6709 +742 4 54.0165 39.6075 29.7175 18.6271 -30.7219 2.56864 +743 4 53.83 39.1099 27.5328 0.819814 -7.88342 20.1611 +744 2 0.845681 38.4599 27.4009 -3.37868 13.1124 0.920574 +745 4 1.3644 39.4179 27.7359 0.635395 -16.0183 -8.53916 +746 4 0.720089 38.4757 26.2839 -0.330424 7.67272 7.0695 +747 4 1.43916 37.5478 27.5772 11.0328 -1.07232 10.5421 +748 1 52.6562 36.7643 28.4919 4.43857 42.1876 29.7882 +749 2 51.8688 35.5726 28.5678 11.3762 10.3615 -9.24037 +750 2 52.1836 34.677 29.7554 -56.6515 -45.7393 26.8579 +751 3 51.2796 33.8674 30.1477 33.9368 21.5747 -13.7315 +752 4 52.2409 37.5914 29.034 7.3769 -32.5773 -16.326 +753 4 50.8037 35.9045 28.6197 0.824464 -11.9292 4.40922 +754 4 51.9818 34.9789 27.6186 -1.74208 2.17118 9.08886 +755 1 53.386 34.609 30.3327 15.9463 0.295407 3.2668 +756 2 53.8702 33.5918 31.2906 -5.336 7.3854 -1.97925 +757 2 53.2724 33.784 32.6972 3.62039 -3.18208 -20.5224 +758 3 53.318 34.8834 33.2435 -3.37109 6.20646 2.08258 +759 4 54.0584 35.341 30.1321 12.3398 9.17802 -3.54281 +760 4 53.5469 32.5903 30.928 0.510164 -2.93777 -2.78072 +761 2 0.450375 33.6574 31.3834 -19.8167 20.6669 9.28695 +762 2 1.1189 33.1041 30.1021 -5.33927 -7.82927 4.13606 +763 2 2.62926 33.3565 30.0201 27.5042 -3.46073 -5.185 +764 2 3.52676 32.4236 30.898 -7.76336 10.6891 3.26174 +765 1 4.93921 32.7908 30.8651 -15.3408 -23.1293 6.29736 +766 4 0.715906 33.1135 32.3077 13.219 -7.49284 0.339296 +767 4 0.711888 34.7596 31.5921 3.25804 -21.2431 -6.20467 +768 4 0.610971 33.6189 29.2485 6.53106 -4.93764 -4.86032 +769 4 0.94328 31.9817 29.9891 -3.372 16.4508 0.497364 +770 4 2.92569 34.3879 30.2717 -10.3735 11.8265 3.32189 +771 4 2.96748 33.277 28.9434 -5.36763 -4.46501 9.75656 +772 4 3.3856 31.3899 30.5364 6.91643 -9.08032 2.48396 +773 4 3.23325 32.4634 31.9813 -4.58699 -1.94284 -9.93441 +774 4 5.35439 32.7181 29.9584 6.30767 5.94328 -10.9381 +775 4 5.52691 32.2429 31.4849 -0.455553 -3.36681 1.56927 +776 4 5.05493 33.7218 31.1915 7.72328 25.1707 0.250012 +777 1 52.7526 32.6794 33.2917 -1.1678 -10.0217 7.16811 +778 2 52.3607 32.6823 34.7156 1.10255 -1.80451 -46.4405 +779 2 53.6298 32.9771 35.466 24.3124 -3.86391 3.03884 +780 3 54.7252 32.4235 35.2212 -23.0397 10.722 4.71956 +781 4 52.6718 31.7771 32.7765 -0.499018 10.5241 3.64804 +782 4 51.648 33.5318 34.8013 -6.43996 -0.39665 8.9378 +783 2 51.7643 31.3153 35.1205 -14.6608 -0.598675 31.299 +784 2 50.4472 31.4454 35.9643 8.77941 -15.5352 -26.1807 +785 2 50.5832 31.9625 37.3651 -2.67912 16.3525 37.5763 +786 3 49.9209 32.9494 37.7433 9.07957 -2.58057 -6.15032 +787 1 51.437 31.3297 38.2211 2.67596 1.57171 0.930055 +788 4 52.5216 30.7277 35.7054 -4.20254 0.0350677 -4.46682 +789 4 51.4878 30.6783 34.2719 3.29993 -4.42069 -15.0162 +790 4 49.9434 30.4567 35.9623 3.78404 -4.63917 10.5702 +791 4 49.6858 32.0412 35.427 2.21977 11.0074 -1.38139 +792 4 51.8063 30.3924 37.9705 2.16328 6.00798 1.3625 +793 4 51.6437 31.7399 39.1747 -6.68696 -10.5036 -22.3596 +794 1 53.5095 33.8962 36.42 -8.20166 25.4414 22.1973 +795 2 54.5747 34.3024 37.3295 -19.3274 -47.2338 19.7644 +796 2 54.3374 33.5175 38.6424 -52.3016 59.5202 -10.0971 +797 3 53.3688 33.7998 39.3891 18.863 -9.21915 -6.06634 +798 4 52.6243 34.4292 36.5865 8.7567 -9.68897 -5.69769 +799 4 0.524888 33.8606 36.995 20.2449 10.0463 -17.6441 +800 2 54.6326 35.7977 37.4305 -12.9517 47.1344 28.5316 +801 2 0.0326923 36.4499 36.0829 -2.43572 -2.53932 -10.8482 +802 2 0.0400304 37.9734 36.2703 -35.7369 26.7596 -9.32276 +803 2 1.42323 35.9178 35.6511 7.48175 21.564 37.2538 +804 4 0.37702 36.205 38.1946 -7.23177 -18.0499 -4.52301 +805 4 53.6103 36.1739 37.8346 22.3749 -7.86488 -15.795 +806 4 54.308 36.1878 35.2646 -5.73883 1.17112 4.65385 +807 4 54.1487 38.389 36.8719 12.989 -15.5349 -14.8375 +808 4 55.0091 38.5546 35.2982 1.66458 -12.2972 11.8538 +809 4 0.898146 38.314 36.8215 26.4509 7.27198 12.604 +810 4 1.38795 34.9003 35.2548 1.76467 -17.1685 3.06812 +811 4 2.15782 36.0461 36.5409 -11.2535 -11.763 -23.0993 +812 4 1.84494 36.4876 34.8385 7.70144 16.3511 -18.9114 +813 1 0.00368541 32.3928 38.6933 60.3495 -72.1401 -12.2197 +814 2 54.849 31.2911 39.6724 -12.054 11.0917 -33.5573 +815 2 0.456178 31.7903 40.9874 10.6429 2.84259 -7.8967 +816 3 1.61925 32.1816 41.0469 -1.25889 2.69502 -0.320895 +817 4 0.771148 32.2113 37.9508 -27.5595 2.34137 31.2634 +818 4 53.7516 31.0568 39.7052 4.35339 2.80588 13.4321 +819 2 0.572301 30.0297 39.0906 18.5839 -9.3637 1.30639 +820 2 0.330271 28.7129 39.848 -4.85336 -14.889 23.6916 +821 2 0.693398 28.6486 41.365 -25.7394 -2.5332 -16.7842 +822 3 54.7394 28.745 0.295995 1.88939 6.38348 7.55667 +823 3 1.88537 28.4667 41.718 12.1129 0.623711 3.73015 +824 4 1.68124 30.2872 39.0755 -12.926 -11.288 -1.20667 +825 4 0.269733 29.7427 38.025 4.32739 20.9521 12.5377 +826 4 0.909417 27.8521 39.409 -5.73579 9.2082 -7.491 +827 4 54.2152 28.4395 39.7334 16.9231 1.48772 2.1114 +828 1 54.6305 31.7883 0.132952 22.8608 6.07746 39.2243 +829 2 54.8576 32.3299 1.48573 -29.3221 31.1311 -21.4901 +830 2 1.17253 32.0229 2.2009 17.6366 -16.111 10.5973 +831 3 1.59057 32.8071 3.07156 -0.674056 0.0659302 -13.788 +832 4 53.659 31.6017 41.9208 -28.5726 -8.3455 -12.917 +833 4 54.8441 33.4787 1.30532 5.06012 -29.8204 14.0187 +834 2 53.6539 32.0394 2.47663 -0.820586 10.1398 -23.6755 +835 2 52.2239 32.3686 2.01123 21.8921 -9.62397 -13.268 +836 3 51.4302 33.0165 2.73635 3.85378 3.64717 10.9914 +837 3 51.8951 32.0293 0.84168 -3.94391 -2.23918 -4.0609 +838 4 53.7898 32.6162 3.39279 8.30271 4.42614 18.4259 +839 4 53.7249 30.9715 2.71423 -6.48233 -12.4206 11.3701 +840 1 1.80027 30.8157 2.00429 -3.41308 17.021 -11.1273 +841 2 3.01391 30.3872 2.67306 -17.4243 6.23421 51.1709 +842 2 4.3573 30.5827 2.00701 -14.1548 15.4243 -63.5733 +843 3 5.42088 30.6338 2.61698 6.51202 -0.211014 15.7475 +844 4 1.38736 30.0831 1.41283 -0.948729 3.54349 -2.60962 +845 4 3.08525 30.9412 3.69277 -1.85342 -9.762 -26.0847 +846 4 2.85031 29.3254 2.98975 11.9317 8.24793 -5.27874 +847 1 4.28888 30.743 0.620497 -12.3621 7.32386 22.4338 +848 2 5.32937 31.2764 41.6512 -13.8663 -29.5394 -9.66616 +849 2 5.57121 32.722 0.10225 -38.3787 16.5244 28.1783 +850 3 4.67744 33.4061 0.685107 26.0808 -18.0695 -15.0621 +851 4 3.36015 30.6914 0.159011 7.3551 0.286523 4.85155 +852 4 6.25759 30.6643 41.7722 1.97617 9.44883 5.82281 +853 2 4.84937 31.1813 40.1487 29.2597 0.863212 8.06821 +854 2 4.69879 29.8019 39.4857 10.4894 -21.0831 -13.1113 +855 2 5.6473 28.6668 39.9936 -13.3021 -14.9024 -16.8737 +856 1 5.27077 28.179 41.3306 -2.96519 4.49812 -11.7353 +857 2 6.06985 28.0105 0.470368 18.4061 -2.74343 27.4639 +858 1 7.404 28.2193 0.415809 -33.9112 -6.97322 0.0250223 +859 1 5.53751 27.6715 1.66745 7.41355 -4.5447 5.6764 +860 4 5.59287 31.7875 39.5584 -6.62026 -5.01092 -0.797873 +861 4 3.90042 31.6963 40.0361 -18.37 16.2558 -2.13315 +862 4 4.87993 29.9347 38.3602 -5.0628 -2.10161 17.6043 +863 4 3.66163 29.4121 39.5629 -5.01534 4.60088 1.06729 +864 4 6.67981 29.0441 39.9161 8.56645 -0.645935 3.00783 +865 4 5.57604 27.7587 39.2774 2.4211 23.1794 17.5601 +866 4 4.26853 28.0084 41.463 -5.17362 0.488763 -0.181308 +867 4 7.82192 28.2777 41.397 19.0269 3.46358 -1.03101 +868 4 7.9555 28.2212 1.28205 9.21585 -1.90571 -0.36079 +869 4 4.50489 27.4888 1.75639 19.7441 2.64647 4.92685 +870 4 6.15841 27.5559 2.53009 -21.7479 0.642981 -21.0512 +871 1 6.76075 33.214 41.6912 19.219 -12.8447 -16.8584 +872 2 7.12868 34.5749 41.8436 1.78261 35.3429 43.0116 +873 2 6.77609 35.3298 40.5962 -19.1975 -45.9981 -46.2181 +874 3 6.48326 34.7082 39.534 6.6414 26.9902 28.4778 +875 4 7.37626 32.7254 41.0127 -5.73863 2.32833 8.30529 +876 4 6.55071 35.0559 0.812315 8.37617 -12.7412 -20.2377 +877 2 8.6392 34.7953 0.238234 19.5739 7.90851 -48.6006 +878 3 9.35353 34.1854 41.0304 -12.8386 -4.95727 8.3137 +879 2 9.11551 34.1669 1.50873 -18.8724 -23.6236 42.9663 +880 4 8.9088 35.8955 0.234805 -6.25165 -9.40588 3.92441 +881 4 10.2786 34.3917 40.988 -0.40493 9.85267 11.4657 +882 4 10.1184 34.4515 1.79035 25.1513 6.04912 0.147779 +883 4 9.07131 33.0605 1.52977 2.37755 -2.72972 -9.56943 +884 4 8.50911 34.4369 2.41136 -0.948376 7.25744 -9.18832 +885 1 6.94474 36.6394 40.6556 -2.44135 26.6434 -23.8261 +886 2 6.9184 37.5467 39.5347 6.69905 -14.1713 -12.8446 +887 2 8.05389 37.1964 38.5245 -27.4859 18.9986 34.7956 +888 3 7.86013 37.2053 37.325 -9.29767 -2.30205 -27.2404 +889 4 7.0965 37.1097 41.5252 4.96112 6.67936 34.6112 +890 4 5.99819 37.3272 38.9586 -4.63141 4.06603 -3.57729 +891 2 6.96111 39.0217 40.0249 7.60343 4.99798 32.9439 +892 2 5.64771 39.5459 40.7503 13.3303 -11.7686 1.87571 +893 2 5.75985 41.0532 41.0609 20.2812 5.99168 -41.4278 +894 2 4.32816 39.2726 39.9704 18.565 3.35099 -29.4893 +895 4 7.21258 39.6788 39.2071 1.58444 12.8598 -26.2647 +896 4 7.87294 39.1662 40.7418 -24.807 -6.41168 -15.2883 +897 4 5.6203 39.0148 41.7319 -7.34537 -3.15131 1.25362 +898 4 4.91646 41.4032 41.6252 -26.0876 7.76092 9.54018 +899 4 5.84653 41.6805 40.0749 -1.44823 -14.0856 28.5036 +900 4 6.60816 41.2866 41.7276 9.52725 -0.69638 -3.08419 +901 4 4.29893 39.8385 38.99 0.215491 -3.12837 12.3269 +902 4 3.42741 39.5069 40.5265 -12.1672 8.54215 8.82184 +903 4 4.17367 38.2217 39.6869 7.24572 -5.84244 0.858739 +904 1 9.22626 36.8637 39.0427 21.4973 3.37181 48.1033 +905 2 10.3674 36.5714 38.2232 -9.10154 -9.23991 0.387697 +906 2 10.2983 35.2598 37.4643 -7.87493 -21.516 -1.82692 +907 3 11.0121 35.0941 36.4546 -10.096 5.18496 3.08952 +908 4 9.43559 37.0753 40.0799 -6.60045 -9.32212 -38.2223 +909 4 10.38 37.3229 37.4195 5.65865 10.6121 -8.5187 +910 2 11.637 36.6734 39.0312 17.5501 -7.37692 6.57672 +911 3 11.6795 35.7227 40.1079 -2.8679 20.1807 -0.19791 +912 4 11.748 37.6704 39.4409 -4.03165 17.0402 13.6797 +913 4 12.5247 36.6276 38.381 6.78129 -14.3562 -2.26856 +914 4 12.1944 34.9922 39.8075 10.5839 -13.8343 -8.97123 +915 1 9.37599 34.317 37.8723 17.0981 22.6825 36.4547 +916 2 9.03961 33.1663 37.0884 -21.5177 -32.5135 -8.8238 +917 2 8.42186 33.6216 35.772 12.1136 -61.8885 -37.6156 +918 3 8.46238 32.81 34.7849 1.32901 29.1307 35.9822 +919 4 8.95542 34.3811 38.853 10.4706 -4.46378 -29.0763 +920 4 9.93142 32.5518 36.7616 2.79547 16.9463 9.21372 +921 2 8.03197 32.1466 37.7484 3.42637 10.6841 -18.9321 +922 2 8.64707 31.2467 38.7916 -6.9544 1.67927 -4.64681 +923 3 8.29676 31.4213 39.9815 6.74685 -6.11142 9.13282 +924 3 9.44706 30.3423 38.4151 3.7337 3.36295 -6.87259 +925 4 7.50152 31.5448 36.9637 8.39997 -2.11551 6.41653 +926 4 7.19405 32.7023 38.1775 -8.25993 10.1263 10.5291 +927 1 7.75009 34.762 35.719 -22.4701 19.7147 -23.1057 +928 2 7.04455 35.3131 34.5484 -10.1936 -29.3849 23.8741 +929 2 7.86233 36.3488 33.8376 -13.0656 11.1044 -41.9487 +930 3 7.58485 36.6599 32.6528 -2.0293 -9.17756 21.4272 +931 4 7.63327 35.3235 36.5488 -2.91413 9.03335 17.0933 +932 4 6.86396 34.4501 33.8456 12.5342 10.3996 -5.08052 +933 2 5.61426 35.844 34.9306 19.6262 -1.52617 -28.8748 +934 2 4.83213 34.6653 35.4025 -10.2806 -24.7237 17.6593 +935 2 4.57558 34.457 36.7787 11.017 23.715 -9.65022 +936 2 4.42364 33.669 34.4835 -0.204454 17.9401 5.69744 +937 2 3.80293 33.3928 37.1817 -18.0339 -16.5573 23.9014 +938 2 3.6203 32.6104 34.8697 -1.59657 -1.57291 16.7967 +939 2 3.28719 32.4878 36.2185 14.3191 25.239 16.785 +940 3 2.42643 31.5967 36.7004 -21.786 -29.0921 6.36516 +941 4 5.08947 36.2348 33.9913 8.47084 3.13833 18.0937 +942 4 5.68856 36.6154 35.7126 -3.45102 11.3715 1.65586 +943 4 4.93536 35.177 37.5545 -2.85956 -5.82375 -8.46254 +944 4 4.68581 33.7849 33.4351 -1.13786 -0.0334624 -10.731 +945 4 3.5508 33.3312 38.3093 3.7661 -3.16504 -32.8067 +946 4 3.21561 31.8879 34.1609 -1.14089 -4.88721 -7.16666 +947 4 2.07822 31.0058 36.0335 4.80509 5.07869 -1.12919 +948 1 8.89276 36.9109 34.4697 3.08208 2.61779 2.42454 +949 2 9.71554 37.9518 33.9536 6.78836 41.9101 -7.41895 +950 2 8.87118 39.1918 33.5791 -2.83098 -3.29658 16.5328 +951 3 9.07345 39.7706 32.5156 6.00915 0.294316 2.75033 +952 4 9.0886 36.6939 35.4314 3.3626 -5.13227 22.9354 +953 4 10.4005 38.393 34.7625 -11.752 -18.5108 -5.62727 +954 2 10.5665 37.5273 32.7526 17.9231 -22.0125 -23.4044 +955 2 11.7038 38.502 32.4536 -20.96 9.74481 -37.2535 +956 3 11.6878 39.1949 31.3977 0.540028 -8.54016 25.273 +957 1 12.687 38.5377 33.3475 38.0496 20.2334 23.5086 +958 4 9.97947 37.4403 31.7814 1.01798 2.165 18.3599 +959 4 11.0193 36.505 32.8955 -2.74071 8.1052 0.988861 +960 4 12.6531 37.864 34.1655 7.32082 17.5294 -13.3715 +961 4 13.4532 39.3055 33.2787 -30.6572 -33.7139 4.421 +962 1 7.93658 39.5767 34.4996 32.6534 -23.6413 -9.43678 +963 2 7.20273 40.8089 34.5743 -2.74612 21.1773 -15.346 +964 2 8.21766 41.8982 34.9197 -3.45605 -13.7782 10.2915 +965 3 8.98784 41.7778 35.8832 -3.40272 -3.46005 -6.10842 +966 4 7.93188 38.9898 35.3424 -7.46187 6.56739 7.86278 +967 4 6.79415 41.087 33.5295 1.97546 -9.26453 20.6229 +968 2 6.06472 40.6271 35.6481 -5.08297 -2.08213 -22.9213 +969 2 4.90833 39.9858 34.8157 -12.6977 -10.7104 -3.72739 +970 2 5.64222 41.9226 36.403 -2.05312 -2.0705 -19.9517 +971 2 3.84054 39.2603 35.6406 -0.0147652 -3.33058 30.6695 +972 4 6.3943 39.8459 36.3734 2.85979 7.06395 10.3389 +973 4 5.33061 39.1839 34.1245 -4.62997 12.2623 4.99778 +974 4 4.37584 40.73 34.1591 8.26763 -2.20969 2.2716 +975 4 4.92993 41.6478 37.2106 -0.0042749 6.0371 4.19307 +976 4 5.15795 0.778755 35.7389 -1.27911 -10.984 2.34352 +977 4 6.51935 0.549814 36.8166 0.412823 -4.00159 10.9885 +978 4 3.21428 39.9846 36.2492 8.55414 -9.22464 -7.99451 +979 4 4.28582 38.4972 36.3757 -6.36125 15.4526 -14.7269 +980 4 3.14756 38.696 34.9847 -1.95473 -0.292674 -1.44435 +981 1 8.25206 1.08297 34.1638 31.3741 38.5442 9.59718 +982 2 9.18814 2.19093 34.4552 -11.7272 -14.356 -0.722089 +983 2 8.45749 3.48131 34.8023 4.76941 7.21795 3.77261 +984 3 7.24176 3.59586 34.6101 4.23254 1.41941 3.46139 +985 4 7.75397 1.25241 33.3001 -16.6469 -12.6897 -14.3012 +986 4 9.75614 1.90919 35.3591 7.11639 4.99627 7.91164 +987 2 10.1452 2.40125 33.2642 -9.36205 3.53781 1.41258 +988 2 11.145 1.26701 33.0621 15.3724 -18.5317 -10.2549 +989 2 12.3408 1.2215 34.0193 -34.6799 -20.8737 -4.25674 +990 3 13.4283 1.6066 33.6334 28.2263 9.73281 -4.88467 +991 1 12.1185 0.540183 35.1633 28.8031 2.35628 29.4382 +992 4 10.7148 3.34616 33.3936 1.59432 0.534457 -2.79864 +993 4 9.49714 2.55965 32.3759 6.01649 -0.268224 -5.10448 +994 4 11.6127 1.34439 32.0577 -0.769775 9.57011 -1.56393 +995 4 10.6933 0.251936 32.9886 -5.52334 3.35231 7.85959 +996 4 11.2139 0.219277 35.5156 -12.526 -0.0546681 -6.86711 +997 4 12.9016 0.455342 35.8573 -9.00019 3.15098 -17.6728 +998 1 9.24699 4.48326 35.2867 7.50516 -22.9453 -9.87373 +999 2 8.79457 5.81029 35.6553 19.4094 -0.44208 23.4194 +1000 2 7.94193 6.35186 34.5098 -28.0836 13.7832 22.6841 +1001 3 8.26577 6.15625 33.3485 3.32417 -1.59684 -17.5239 +1002 4 10.2626 4.25405 35.3107 -8.01304 16.2193 5.9612 +1003 4 8.1894 5.68577 36.5846 -11.6257 -0.00282829 -7.04897 +1004 2 9.97767 6.74716 36.1433 -23.7266 14.1696 -20.2452 +1005 2 11.1395 6.93836 35.1562 2.17384 -4.68321 -25.171 +1006 2 12.442 7.40754 35.8023 6.89417 23.6707 25.6501 +1007 2 12.3585 8.87197 36.3546 -17.7601 7.18701 6.16378 +1008 1 13.652 9.40345 36.7619 -5.05233 -10.0697 25.3038 +1009 4 10.4674 6.41708 37.0624 -6.17454 -12.8958 16.6295 +1010 4 9.46609 7.72624 36.4439 19.6997 -12.4825 -9.52898 +1011 4 10.8586 7.67723 34.3661 -2.31205 -2.27426 2.47252 +1012 4 11.3956 5.98923 34.5935 -8.15618 9.36142 7.97067 +1013 4 13.285 7.3766 35.0989 4.02069 -2.74272 -14.2107 +1014 4 12.7725 6.74228 36.6382 -4.94702 -0.810609 -4.3443 +1015 4 11.6162 8.97546 37.2517 21.5709 -5.37851 -23.6156 +1016 4 11.9848 9.59279 35.5592 1.32622 -13.234 7.43529 +1017 4 13.5097 10.3531 37.0548 1.1249 12.5728 4.15723 +1018 4 14.3076 9.4933 35.9914 2.38442 -5.54985 1.16984 +1019 4 14.0989 8.9471 37.5942 -8.28554 10.0467 -28.7492 +1020 1 6.74258 6.95961 34.8453 13.8439 -7.08515 -31.5666 +1021 2 5.70412 7.47847 33.9372 22.4359 17.1833 28.8896 +1022 2 4.73468 6.47268 33.3926 -37.2702 -51.3286 -21.7325 +1023 3 3.66084 6.82477 32.8505 20.0183 9.28716 8.38675 +1024 4 6.50761 7.12516 35.8163 -0.959582 1.3178 20.8718 +1025 4 5.07512 8.17388 34.5809 1.06569 -12.1955 -8.24357 +1026 2 6.27511 8.35576 32.8097 23.4106 2.51452 -13.5767 +1027 2 6.97942 9.67377 33.2004 -16.9954 14.0421 10.4255 +1028 2 6.10535 10.8129 33.826 12.866 -26.3315 -27.4761 +1029 3 5.32563 11.4369 33.048 -2.57309 4.89094 -0.177716 +1030 3 6.28787 11.1355 35.0235 5.56298 3.82152 16.5631 +1031 4 5.49496 8.55729 32.0786 -16.2509 9.70978 -5.42728 +1032 4 7.00993 7.79082 32.1666 -6.62982 -1.98309 13.432 +1033 4 7.44051 10.1227 32.2823 5.63402 -3.39012 2.91122 +1034 4 7.79617 9.4262 33.9151 4.88029 0.56984 -5.69246 +1035 1 4.9985 5.11713 33.407 24.659 21.8647 21.6253 +1036 2 4.05493 4.11234 32.9569 -19.5991 11.2557 -30.6753 +1037 2 2.66349 4.36425 33.564 5.77052 11.5327 33.941 +1038 3 2.61183 4.63212 34.7889 -10.6254 -2.1096 -24.9185 +1039 4 5.90798 4.72579 33.7623 -18.8375 16.0079 -6.75199 +1040 4 3.94963 4.2178 31.8123 4.18537 -9.18741 21.4869 +1041 2 4.52113 2.73738 33.4375 8.25229 -17.2331 29.0433 +1042 3 5.75234 2.38881 32.7881 -21.5054 -2.62865 -12.7372 +1043 4 3.76903 1.95227 33.2696 -3.85539 -5.9091 -13.5606 +1044 4 4.62925 2.69715 34.589 6.20333 6.93314 -25.3828 +1045 4 6.43526 2.61043 33.3995 7.46021 4.72267 11.925 +1046 1 1.55191 4.21884 32.8032 -14.0425 -5.15851 -21.6842 +1047 2 0.161375 4.25438 33.2368 -9.40026 13.4655 23.096 +1048 2 54.692 2.80115 33.3646 18.1492 -1.83923 -37.1888 +1049 3 54.7885 2.04564 32.3679 -9.76904 2.34815 11.9713 +1050 4 1.58614 3.87283 31.8209 11.2241 6.42129 12.946 +1051 4 0.0932821 4.78062 34.2407 6.57702 -9.00044 -6.29593 +1052 2 54.1421 5.03026 32.3092 -30.8516 -27.3257 32.8914 +1053 3 54.4529 6.38645 32.3432 43.6526 11.7784 12.1317 +1054 2 52.6693 5.00292 32.8811 18.0931 2.75777 -15.9968 +1055 4 54.1554 4.62002 31.3044 4.18983 -2.87474 -22.2473 +1056 4 53.8639 6.90955 31.8518 -25.2917 13.9269 -18.693 +1057 4 52.66 5.46781 33.8932 -7.48107 5.39969 -2.18241 +1058 4 52.249 3.98991 33.0062 0.231344 -5.48034 -3.27193 +1059 4 51.9963 5.5356 32.1423 1.66512 -1.40627 14.088 +1060 1 54.1705 2.41097 34.5199 1.80418 26.5965 31.5441 +1061 2 53.4771 1.1604 34.7223 -23.5881 -17.4143 30.2256 +1062 2 51.9672 1.43692 34.4286 45.4706 11.6959 19.6168 +1063 3 51.5098 2.51334 34.8139 -14.0548 -1.70012 -4.22959 +1064 4 54.1449 3.13072 35.3168 -2.84084 -28.6208 -21.3152 +1065 4 53.8073 0.317305 34.0552 7.54144 10.0832 -0.542806 +1066 2 53.6466 0.727247 36.2732 15.0023 -0.977243 -19.0787 +1067 2 0.11045 0.778115 36.8855 -3.47233 23.3808 -12.4462 +1068 2 0.174657 0.0352411 38.2454 9.71436 -6.65086 -1.81426 +1069 2 1.19132 0.222888 35.8995 6.11034 15.7938 3.95568 +1070 4 53.2393 41.6189 36.352 -4.11551 -11.0062 3.39296 +1071 4 53.0266 1.35722 36.9407 -10.5209 2.31976 -3.99924 +1072 4 0.276909 1.89779 37.0745 11.3679 -17.77 -1.06189 +1073 4 54.361 0.442618 38.9125 4.10216 -8.97134 2.26246 +1074 4 1.16474 0.174268 38.7716 -10.2453 4.64912 -5.91146 +1075 4 0.0894693 40.827 38.1128 -8.07449 10.5575 2.47406 +1076 4 2.18017 0.0911741 36.3628 0.498668 -8.86502 15.8712 +1077 4 1.51082 0.946112 35.1046 -21.6742 -5.82018 -4.77892 +1078 4 0.87048 41.1455 35.5035 3.84873 -0.316194 -7.96637 +1079 1 51.2572 0.510776 33.7869 -35.0849 -22.21 -18.422 +1080 2 49.7991 0.651464 33.5457 -7.89552 -1.42073 2.85742 +1081 2 49.1064 41.7127 34.6422 20.8091 24.7993 -30.4476 +1082 3 49.3211 40.5176 34.6928 0.936017 -16.9834 6.81615 +1083 4 51.5685 41.4333 33.6514 6.90564 11.6478 3.53197 +1084 4 49.4699 1.73569 33.6536 7.71362 -9.58165 1.5915 +1085 2 49.2914 0.124722 32.1435 -1.6477 0.542595 21.3952 +1086 2 49.5957 1.07684 31.016 -40.6033 -15.585 26.437 +1087 1 48.7294 1.99918 30.4836 -27.6566 13.4748 -4.54446 +1088 2 50.7297 1.21695 30.3262 36.7247 10.1326 -33.1818 +1089 2 49.2902 2.59089 29.4013 15.6758 12.8861 -16.3634 +1090 1 50.5605 2.13547 29.3267 -27.6128 -3.77706 23.4645 +1091 4 48.1729 41.8384 32.2733 14.3125 6.04861 -12.1255 +1092 4 49.7214 41.0254 31.9181 -0.443629 4.48635 2.11286 +1093 4 47.7408 2.2006 30.8029 20.1006 -6.4749 -2.25561 +1094 4 51.6449 0.698065 30.4056 15.084 -12.5894 5.57169 +1095 4 48.9104 3.2954 28.6425 -5.47018 -10.6135 19.6435 +1096 4 51.2563 2.40703 28.6421 12.9903 7.46191 -13.5301 +1097 1 48.3611 0.457254 35.523 -13.4783 35.8963 4.98689 +1098 2 47.6684 41.7265 36.6028 -12.609 2.82517 16.7739 +1099 2 46.2613 41.336 36.1362 14.2498 9.86212 -6.63619 +1100 3 45.3696 0.249228 35.9008 11.2544 -8.11188 8.40093 +1101 4 48.1527 1.47601 35.3837 2.04907 -15.0615 5.33592 +1102 4 48.2568 40.8085 36.8471 -2.89667 -2.02658 5.80089 +1103 2 47.5596 0.692305 37.8969 5.07609 12.8861 -15.4572 +1104 2 46.7247 0.067171 39.0652 -23.3887 -7.36646 -24.3057 +1105 2 47.033 40.4837 39.4166 -14.2982 16.8046 -18.6717 +1106 2 46.9311 0.907751 40.3269 20.2628 20.9695 31.7148 +1107 4 47.0803 1.72619 37.5586 18.4264 -28.4903 17.3716 +1108 4 48.6288 0.838001 38.2574 -15.841 5.68773 -4.62102 +1109 4 45.6307 0.107149 38.6982 15.4635 0.946246 17.2142 +1110 4 48.0197 40.3992 39.8616 17.8935 -6.94949 10.1905 +1111 4 47.0012 39.8155 38.524 1.84183 3.03864 3.36861 +1112 4 46.2605 40.0937 40.1174 3.5183 -0.242765 2.2201 +1113 4 48.0596 1.05972 40.5786 -27.9597 -7.64804 -5.61245 +1114 4 46.4366 0.492644 41.2461 4.13191 -4.52617 -8.48469 +1115 4 46.5029 1.93558 40.2678 1.33797 -2.98423 -8.86627 +1116 1 46.1363 40.0225 35.9719 -11.8784 -48.163 0.632693 +1117 2 44.9067 39.2611 35.7716 22.3959 0.0668878 -14.2888 +1118 2 44.4049 38.8629 37.1725 -35.2322 11.6067 -22.5418 +1119 3 45.1472 38.486 38.0617 14.0918 -2.68919 9.70234 +1120 4 46.908 39.3425 36.1226 1.34088 13.782 2.29065 +1121 4 44.2497 39.8817 35.1331 -17.245 4.97255 12.4072 +1122 2 45.2366 37.985 34.8925 -4.99104 -6.23114 -9.17669 +1123 2 44.0069 37.0072 34.8313 5.26574 11.342 7.98842 +1124 2 45.6195 38.3915 33.4226 -3.76358 -20.0352 6.70883 +1125 4 46.1177 37.4383 35.3134 -3.76426 -1.15462 7.05426 +1126 4 43.5316 36.9313 35.8696 0.358942 -6.34703 -24.4349 +1127 4 44.3242 35.9956 34.5249 4.20531 -7.16171 2.34616 +1128 4 43.2753 37.3126 34.0403 -3.87397 3.42825 10.5933 +1129 4 46.6384 38.8467 33.4221 -3.79452 2.69366 -2.61982 +1130 4 44.9004 39.1304 33.0043 0.823619 -0.608417 -3.73086 +1131 4 45.6564 37.4663 32.7381 0.0287792 19.4258 11.3413 +1132 1 43.0561 38.9062 37.36 16.7964 -0.846157 38.4014 +1133 2 42.4272 38.5172 38.6279 -14.5421 -18.7427 13.0828 +1134 2 41.8753 37.0763 38.5124 -8.78692 12.5845 -64.2445 +1135 3 41.466 36.6885 37.3717 6.29707 6.96761 32.6735 +1136 4 42.3774 39.0214 36.6331 -15.2734 7.16413 -28.2079 +1137 4 43.1919 38.4467 39.4108 16.1917 0.0561369 8.47296 +1138 2 41.3404 39.5151 39.1514 -18.2527 2.1619 5.40726 +1139 2 42.0205 40.8503 39.6333 -29.5812 13.2835 -20.5362 +1140 2 41.0689 0.171231 39.4112 30.2059 17.4331 -9.29433 +1141 2 42.4678 40.816 41.1078 15.9246 -23.8206 -10.1516 +1142 4 40.688 39.0893 39.9799 16.7303 0.907162 -6.07322 +1143 4 40.5588 39.6983 38.3606 15.4269 0.857054 0.728379 +1144 4 42.8535 41.0549 38.9416 17.5291 -0.3509 1.61726 +1145 4 41.6271 1.1561 39.6676 -14.9721 -22.7636 -0.520954 +1146 4 40.1564 0.111331 40.0029 -13.6089 -0.269988 10.9836 +1147 4 40.76 0.320829 38.3386 1.94315 -8.64923 8.74761 +1148 4 41.6626 40.4848 41.7802 -9.99726 5.60483 6.07701 +1149 4 42.8258 41.8281 41.4135 4.90552 -5.57863 6.49728 +1150 4 43.2679 40.0127 41.241 -4.54696 19.1865 -0.92221 +1151 1 41.8233 36.2733 39.5754 -3.61756 -11.0936 16.9633 +1152 2 41.1922 34.957 39.6399 -10.4088 -17.6704 -50.7121 +1153 2 39.8412 35.0841 40.3193 -0.437683 4.39576 10.763 +1154 3 39.8144 35.4746 41.4864 -9.76 5.96233 -2.547 +1155 4 42.2323 36.5766 40.4577 6.86651 4.46574 10.4638 +1156 4 40.9934 34.6386 38.4963 8.65196 -1.15376 42.0164 +1157 2 42.0562 33.8903 40.4247 20.8855 33.0106 -9.02378 +1158 2 41.3005 32.6543 41 38.0556 15.2529 -12.1112 +1159 2 42.2217 31.3951 41.1067 -29.8496 -30.3433 -13.4218 +1160 1 43.3285 31.549 0.111927 13.7517 39.8644 23.5527 +1161 2 44.3839 30.7268 0.286736 21.6234 19.2182 17.9174 +1162 1 44.681 29.6113 41.5428 -25.8767 -16.3024 -25.7307 +1163 1 45.3493 31.1499 1.13058 -39.3833 23.49 -6.35183 +1164 4 42.617 34.5166 41.192 -12.3652 -23.3828 3.531 +1165 4 42.8948 33.5841 39.7601 -4.64767 -6.80459 -5.17496 +1166 4 40.4819 32.4474 40.3056 -13.8786 -11.9041 -4.8646 +1167 4 40.8645 32.9834 0.0421702 -8.7777 -8.2778 13.4879 +1168 4 42.5872 31.067 40.0872 -0.36901 12.0823 9.30135 +1169 4 41.553 30.5032 41.4129 16.6518 20.7036 2.18161 +1170 4 43.3615 32.497 0.627799 -1.11121 -36.4642 -14.6418 +1171 4 44.0326 29.3067 40.7749 11.9664 -0.606259 12.9296 +1172 4 45.4908 28.9966 41.7635 -4.5997 7.04477 0.652143 +1173 4 45.2947 32.0222 1.6989 -3.32167 -9.1207 -8.17541 +1174 4 46.1369 30.5772 1.3332 29.28 -20.6173 7.21336 +1175 1 38.7318 34.7203 39.6307 -5.56998 -4.40152 -32.2775 +1176 2 37.3555 34.7738 40.1542 17.1032 1.0045 -6.37855 +1177 2 37.2353 33.667 41.1913 -33.3614 37.0741 40.0449 +1178 3 37.7005 32.5636 40.9891 18.731 -32.0974 -3.65368 +1179 4 38.8335 34.3404 38.6486 -6.51334 12.5121 23.5529 +1180 4 37.2672 35.7762 40.6273 -9.086 1.46109 5.84779 +1181 2 36.2453 34.5638 39.0845 -6.93832 -9.37108 -7.97374 +1182 2 36.1701 35.614 37.9414 8.91404 15.2365 -6.3275 +1183 2 35.3527 35.0344 36.7472 39.8054 8.21108 -27.9 +1184 2 35.4841 36.9314 38.4139 -18.287 13.7727 -16.8718 +1185 4 35.232 34.5024 39.5744 7.45292 -0.257102 0.0904576 +1186 4 36.3852 33.5433 38.6164 0.781265 7.17557 6.89015 +1187 4 37.2115 35.9047 37.5843 -11.2451 -10.8797 5.10717 +1188 4 35.5662 35.6385 35.778 -16.1675 -5.48794 25.897 +1189 4 34.291 34.967 37.0013 -15.7304 -0.876038 -4.35202 +1190 4 35.7074 34.0135 36.4456 -4.10332 3.28733 9.08934 +1191 4 35.4655 37.7439 37.5577 -4.97646 -27.0735 23.6494 +1192 4 36.0148 37.4196 39.237 12.1669 1.46201 8.99598 +1193 4 34.4369 36.7462 38.8365 16.8945 3.16641 -16.172 +1194 1 36.5334 33.9935 0.435925 10.1465 7.38421 -15.9691 +1195 2 36.4058 33.2568 1.6875 16.4821 -29.3274 -13.0782 +1196 2 35.1468 33.6833 2.42741 -3.52585 26.4938 2.22063 +1197 3 34.7699 34.8785 2.50349 9.50092 -20.8144 -9.83338 +1198 4 35.9506 34.8486 0.439937 7.33038 -6.12466 -5.51472 +1199 4 36.3499 32.1247 1.42412 1.62075 26.2077 7.36918 +1200 2 37.675 33.5505 2.58336 -0.681506 -6.35683 7.58589 +1201 2 37.7854 32.6927 3.8625 18.6921 -17.668 32.0141 +1202 2 39.0575 32.9332 4.76873 14.2724 -20.5826 -30.9069 +1203 1 39.1289 34.2491 5.33109 11.0713 19.2422 13.5273 +1204 2 40.0441 34.6938 6.2528 -38.5124 5.77538 -21.346 +1205 1 41.0523 34.0015 6.75388 -9.3068 -30.315 -40.8639 +1206 1 39.7573 35.8959 6.75045 4.65044 -37.6482 -19.533 +1207 4 37.7117 34.6025 2.94212 -4.78803 6.98284 -11.1897 +1208 4 38.6033 33.3783 1.98429 -1.50456 2.19712 -0.683264 +1209 4 37.8193 31.5994 3.65006 -4.42508 0.799529 -11.9295 +1210 4 36.9318 32.7949 4.56147 -11.5542 5.52665 -5.70323 +1211 4 39.9727 32.6563 4.13477 -10.3426 12.9457 13.0222 +1212 4 39.0991 32.232 5.62646 -6.41615 -9.9444 -1.6393 +1213 4 38.3112 34.8566 5.12728 9.08197 -0.1797 3.06874 +1214 4 41.338 33.0965 6.26824 1.29043 26.2885 21.8424 +1215 4 41.5567 34.3995 7.53172 18.6054 -2.34736 15.9895 +1216 4 38.9283 36.4191 6.51463 -17.6749 8.57537 -7.4588 +1217 4 40.3535 36.2619 7.44459 24.2502 25.7988 36.1589 +1218 1 34.4423 32.7029 2.99518 -5.91218 -18.2551 8.17758 +1219 2 33.2643 32.9205 3.78866 2.14491 3.18155 15.0212 +1220 2 32.3114 31.74 3.93685 27.6029 1.93064 -50.2862 +1221 3 31.6521 31.6162 4.95167 -20.1995 -6.42992 23.3772 +1222 4 34.7506 31.7123 2.9878 2.11082 4.57648 -1.08475 +1223 4 33.5885 33.2179 4.82725 -4.56531 -3.45872 -11.3922 +1224 4 32.6993 33.791 3.40271 -6.19117 1.50996 -1.33542 +1225 1 32.2733 30.8792 2.86255 -3.44833 -0.807911 26.2314 +1226 2 31.5067 29.6456 2.87911 -22.6819 -12.0155 6.38652 +1227 2 32.0275 28.5204 1.99364 -17.4826 -15.7648 -26.1521 +1228 3 31.24 27.9052 1.1757 18.2868 13.9435 17.0259 +1229 4 32.9257 31.0189 2.07167 -6.99587 -10.4877 -2.31778 +1230 4 31.4409 29.1882 3.92659 1.7726 14.0477 -11.6562 +1231 4 30.4172 29.8482 2.57519 20.7941 0.876843 7.98191 +1232 3 33.2432 28.1769 2.02662 6.75216 10.2675 5.6015 +1233 6 29.6689 33.0345 2.6027 6.39732 3.7635 -6.59735 +1234 4 28.7656 33.0857 2.95028 -0.371973 -14.4593 -6.85361 +1235 4 29.8153 32.1814 2.14015 -8.59972 11.6466 4.8732 +1236 6 1.91326 24.7635 28.0772 5.65317 -6.35183 16.4854 +1237 4 1.01929 24.4316 28.2568 3.94453 1.46201 -0.938269 +1238 4 2.46517 24.4471 28.8255 -6.59296 2.11781 -11.8027 +1239 6 8.98979 35.4216 7.06427 2.13264 0.908259 -3.07356 +1240 4 8.22375 36.0041 6.95701 -0.608539 -3.26387 0.365744 +1241 4 9.74616 35.991 6.87666 4.70766 2.91314 -0.442423 +1242 6 37.9357 35.2342 23.5273 -23.102 9.18642 19.8247 +1243 4 37.5041 35.2968 22.6705 0.513901 -3.82007 -8.89977 +1244 4 38.8432 35.0218 23.4038 20.8563 -8.17935 -11.4372 +1245 6 11.3793 34.6137 20.3253 14.1507 4.32837 -4.20952 +1246 4 10.4755 34.624 20.6003 -22.0831 6.77293 1.73618 +1247 4 11.7264 33.9016 20.8561 13.9299 -11.0914 4.04985 +1248 6 3.06607 13.1144 13.5167 22.577 18.8722 18.6067 +1249 4 2.20388 12.8262 13.8046 -7.02328 -4.57126 0.810516 +1250 4 3.32154 13.8092 14.1761 -2.44089 -14.0351 -15.8923 +1251 6 9.17443 22.3777 24.8954 -7.42914 3.56866 8.74917 +1252 4 9.07626 22.0242 24.0039 2.26474 -2.4656 -3.7019 +1253 4 8.26912 22.4958 25.2295 3.15193 -1.43545 -3.27774 +1254 6 31.1464 36.1236 7.45234 10.6607 -18.1227 -24.2194 +1255 4 30.9334 35.2222 7.12747 -5.34615 12.6105 12.538 +1256 4 31.8314 36.3443 6.79825 -5.43643 8.62165 8.26122 +1257 6 20.3227 0.172698 30.1419 10.3105 -3.05703 7.76208 +1258 4 20.0388 1.0684 29.8874 5.3247 -3.32009 0.781739 +1259 4 21.2583 0.228399 30.4322 -11.2768 6.47679 -5.28094 +1260 6 32.6859 3.01778 5.15829 -10.6028 -19.0303 43.6625 +1261 4 32.0356 2.3058 5.02019 7.54008 9.83835 -8.28794 +1262 4 32.7128 3.00557 6.15578 5.12118 6.62375 -23.7252 +1263 6 26.2374 8.27856 11.5971 17.869 0.788073 20.0593 +1264 4 26.2346 7.39991 12.0216 -0.142457 7.42091 -4.28305 +1265 4 26.8978 8.79254 12.1302 -17.5189 -15.6641 -18.5798 +1266 6 1.09614 20.2561 0.875192 -22.9747 0.467748 19.1373 +1267 4 0.851949 19.3199 1.10255 19.4844 20.3298 -11.3195 +1268 4 1.85437 20.3448 0.297385 12.1513 -16.76 -9.59627 +1269 6 29.1514 22.9126 1.42851 -3.57267 15.5796 12.2113 +1270 4 28.6966 23.7416 1.67141 5.52941 -12.1705 -9.88265 +1271 4 29.6634 22.7027 2.22543 0.165437 -2.26551 -2.85175 +1272 6 34.1399 34.826 6.47271 -4.00425 12.5535 -7.93856 +1273 4 34.8635 34.3401 6.10458 13.259 -3.54932 -9.87122 +1274 4 33.9387 34.3337 7.25184 -8.28913 -2.66912 16.7304 +1275 6 25.1643 37.1931 26.5228 17.2229 -22.0393 -23.1844 +1276 4 24.6935 37.7676 27.1042 -4.31343 22.2846 18.4719 +1277 4 26.0117 37.6203 26.271 -7.79876 5.52479 6.28113 +1278 6 14.5333 22.2337 15.6719 -21.8235 -40.5779 4.16881 +1279 4 14.0435 21.3187 15.7268 23.5152 50.9834 -4.51283 +1280 4 14.2451 22.7392 14.8947 -1.224 -10.8945 3.63574 +1281 6 2.86145 5.86342 4.09514 -12.0928 12.5672 -7.55007 +1282 4 3.31871 5.53612 4.87755 -0.114002 3.3263 11.1441 +1283 4 2.36891 6.69134 4.30817 11.5092 -15.7361 4.93451 +1284 6 27.6072 26.7133 22.7037 11.3111 -21.4893 35.9413 +1285 4 26.8221 26.1673 22.7712 -7.10606 -4.70529 -2.97044 +1286 4 27.5145 27.2572 21.9514 -10.0855 20.8317 -32.7258 +1287 6 17.7799 0.609907 22.4001 -5.17757 10.6635 4.04288 +1288 4 17.0763 0.657064 23.0885 11.5181 4.04392 -9.91171 +1289 4 18.0806 1.5364 22.261 -7.85301 -10.5281 2.59652 +1290 6 8.08893 9.42761 10.5595 3.55537 5.25916 40.324 +1291 4 7.89361 10.322 10.3179 -9.19974 15.7377 -19.3495 +1292 4 8.16563 9.56196 11.5399 2.2102 -21.2534 -20.7584 +1293 6 15.3508 8.71886 30.755 5.09068 -14.416 21.7005 +1294 4 15.721 8.98141 29.9127 -5.17651 10.4904 -11.2194 +1295 4 14.5411 9.19598 30.997 6.64715 3.62724 -9.30987 +1296 6 11.0273 17.2714 37.5546 -8.62993 4.63856 -3.16721 +1297 4 10.646 18.1523 37.5049 13.3861 11.3255 -4.88271 +1298 4 10.2437 16.8378 37.8681 -2.55755 -24.0409 7.53141 +1299 6 42.0954 25.1585 20.3881 14.6842 1.84925 -24.6227 +1300 4 41.6997 25.8318 19.7943 -2.16553 -3.48259 16.6789 +1301 4 41.6994 25.1952 21.2528 -9.02961 7.39914 10.888 +1302 6 25.8656 4.70522 33.8434 4.94337 -17.9304 30.0995 +1303 4 25.7948 4.41246 32.9437 -1.56424 4.53154 -20.9619 +1304 4 25.7821 5.65919 33.9019 -2.93726 10.638 -9.31877 +1305 6 28.7565 10.7943 24.343 5.31048 -5.66707 -17.5237 +1306 4 29.0395 10.691 25.2776 6.61806 -8.7001 -20.887 +1307 4 29.3174 10.2678 23.7025 -8.86987 6.64124 26.5787 +1308 6 5.00601 41.813 11.1 6.11697 -35.3303 28.6791 +1309 4 5.97939 41.6679 11.0741 -12.7816 8.03831 -2.02432 +1310 4 4.68345 41.1078 11.7429 5.5471 25.1349 -25.8779 +1311 6 51.7607 12.785 30.1531 41.9873 7.8243 6.58168 +1312 4 51.5044 13.1989 29.3224 -3.76645 3.26875 -7.63234 +1313 4 52.7548 12.9452 30.2104 -29.821 -7.22149 1.35463 +1314 6 7.60527 6.19156 6.53697 16.5093 0.883216 -0.386471 +1315 4 6.7728 6.50088 6.91441 -4.77803 -9.70632 -1.71599 +1316 4 7.48617 5.31021 6.15237 -11.2115 3.19853 1.4886 +1317 6 14.6639 26.9856 30.1439 5.75321 15.8705 11.2484 +1318 4 14.5566 27.0259 31.1175 -3.12227 -7.05885 -13.9758 +1319 4 15.1715 27.7926 29.9326 -6.11328 -7.83436 0.701957 +1320 6 15.3386 3.73742 21.1629 -49.5233 -4.42818 1.41573 +1321 4 14.7513 4.15862 21.8308 22.5595 -2.74077 -5.2282 +1322 4 14.679 3.20837 20.6508 28.7222 9.19721 3.95726 +1323 6 18.6168 30.4391 6.46727 22.6827 -23.6706 30.2016 +1324 4 19.0357 29.7477 7.08277 -19.2097 26.0479 -21.7287 +1325 4 19.3376 31.0911 6.37388 -10.7119 -2.89972 -1.77141 +1326 6 40.7683 1.30949 12.8061 -7.58564 4.37034 -9.51004 +1327 4 39.8743 1.70123 12.8539 8.02325 -2.8267 0.614513 +1328 4 41.1302 1.62292 11.9594 1.79027 -4.37486 1.66609 +1329 6 17.747 20.7401 41.5828 -14.5708 23.9699 -22.25 +1330 4 16.8287 21.1121 41.5273 18.852 -12.8662 8.2158 +1331 4 18.269 21.3043 40.983 -0.296974 -7.34806 11.4382 +1332 6 20.4522 2.1467 12.3338 -13.8993 16.4183 -18.7538 +1333 4 19.8428 1.38545 12.4588 7.32118 14.6694 -7.56396 +1334 4 20.1591 2.61844 11.4836 4.96023 -26.6086 29.2353 +1335 6 9.8437 37.1731 18.0697 32.5344 -3.69518 -7.02483 +1336 4 9.9915 37.607 18.9153 -11.6933 2.16478 7.61773 +1337 4 10.7629 37.1686 17.7045 -22.2666 -4.61022 -1.39483 +1338 6 22.8273 7.39987 18.8956 -5.5011 7.28813 -36.492 +1339 4 23.2632 7.84344 18.1165 -7.98371 -8.25387 20.5209 +1340 4 21.8866 7.2843 18.6392 14.3432 0.686453 4.84686 +1341 6 12.8601 6.85899 39.0577 6.92589 -13.3495 -12.6124 +1342 4 12.2887 7.60854 39.1608 -14.8411 14.7282 0.271429 +1343 4 13.3423 6.79713 39.8797 5.00888 -0.905409 12.2129 +1344 6 10.1643 2.40912 23.2548 -13.4149 21.1074 -1.06732 +1345 4 10.2774 2.03439 22.3894 8.18098 -13.9841 -15.6202 +1346 4 9.49692 3.09648 23.049 6.99386 -4.39158 13.7206 +1347 6 12.5495 20.2147 19.5723 7.26787 8.21028 -18.3895 +1348 4 11.6895 19.7983 19.735 -1.5185 0.18686 -8.43892 +1349 4 12.6119 20.404 18.6017 -2.05058 -6.51038 26.2392 +1350 6 53.8702 6.35891 18.9198 29.7306 -6.18586 8.10346 +1351 4 53.0457 6.06715 19.2818 -21.258 -2.7468 0.110915 +1352 4 54.4788 6.08079 19.6257 -1.29631 10.1734 -11.3531 +1353 6 1.76233 4.00968 13.2412 15.2049 -20.178 -6.82767 +1354 4 1.1126 4.5015 13.7221 -14.7745 7.27862 5.55391 +1355 4 1.46634 3.0803 13.3195 6.22895 8.64986 -3.00031 +1356 6 2.68809 16.4658 4.58471 15.0105 -8.44828 17.4213 +1357 4 3.47968 16.3912 5.17607 -18.0483 5.65918 -16.5792 +1358 4 2.952 17.0668 3.88721 1.61121 4.43717 -9.18758 +1359 6 22.6412 7.38905 35.0491 -42.342 -19.7774 -51.2585 +1360 4 21.8701 7.10292 34.411 47.7649 22.3984 34.2121 +1361 4 22.4927 6.7758 35.7601 0.300803 -9.30322 17.5195 +1362 6 30.6449 27.8966 19.9 11.2186 24.5725 -17.4668 +1363 4 31.067 28.6028 19.3405 -15.311 -24.4133 12.7333 +1364 4 30.0502 27.364 19.3383 6.18265 4.0422 4.40167 +1365 6 18.3584 9.54031 6.21119 11.0026 -3.68808 23.2716 +1366 4 18.3645 9.12256 5.3612 -2.33489 -5.22153 -19.3682 +1367 4 19.1216 9.13552 6.66909 -8.40358 6.03455 -2.63927 +1368 6 21.0207 30.3946 30.8361 -20.2261 -14.3153 8.76877 +1369 4 21.7305 31.0371 30.8947 0.539155 4.23503 10.2216 +1370 4 20.6128 30.1908 31.727 18.9681 11.2591 -24.4987 +1371 6 28.3223 4.36971 15.0862 0.785553 22.566 1.53388 +1372 4 27.9162 3.53142 15.2341 -13.4814 -22.4749 6.99245 +1373 4 29.0547 4.16931 14.5133 14.7433 -0.183871 -4.75122 +1374 6 12.7699 0.652736 16.5284 -10.9622 36.0111 -3.70833 +1375 4 13.1417 1.43405 17.0195 -7.22472 -23.339 -11.6266 +1376 4 12.1312 1.03058 15.8629 17.1298 -5.78525 17.4901 +1377 6 27.5613 35.204 8.24204 -17.5468 -3.17574 2.50179 +1378 4 28.0037 35.3359 7.41158 3.58667 2.22765 -10.9792 +1379 4 26.8513 34.5538 8.04841 12.0719 12.2779 8.55847 +1380 6 24.0727 5.16129 41.0114 25.3265 34.0312 4.62534 +1381 4 24.5764 6.00631 41.0278 8.83913 -22.6202 16.662 +1382 4 23.4512 5.41721 40.3589 -27.9927 -11.5371 -21.4854 +1383 6 16.8577 24.9409 28.3044 -13.362 20.9446 -8.34262 +1384 4 15.8529 24.9248 28.4711 42.0709 9.51562 -15.4474 +1385 4 17.0929 25.6637 27.6385 -20.1406 -20.6283 22.1367 +1386 6 20.8367 12.7872 17.016 48.1357 -13.7972 -0.957512 +1387 4 20.9831 13.7012 17.3244 -4.24853 -6.44611 -2.53838 +1388 4 21.7731 12.3998 16.8344 -46.2893 13.5674 8.59046 +1389 6 35.7698 23.0286 30.9167 1.31549 -8.15919 10.0357 +1390 4 34.8007 23.0783 30.9694 4.38358 -0.634017 0.107585 +1391 4 36.0504 22.6611 31.7855 -2.79806 7.45108 -14.1947 +1392 6 36.3049 21.4 25.8723 16.8231 15.2703 -10.059 +1393 4 35.3849 21.2313 25.7163 -23.5769 -6.11261 -4.10927 +1394 4 36.6855 20.6326 26.2849 5.24534 -13.4215 6.45433 +1395 6 13.4896 6.74946 5.28081 -28.3592 57.2786 25.4238 +1396 4 13.8414 6.02988 4.86679 44.4058 -71.9847 -33.7479 +1397 4 12.7199 6.9047 4.75258 -19.8414 9.95147 -1.72496 +1398 6 20.8046 20.4221 13.7595 5.24729 11.8597 -23.4966 +1399 4 21.3314 20.3763 14.5586 1.04488 -1.4591 8.76088 +1400 4 19.8874 20.2651 13.9627 -8.54986 -4.70556 7.47732 +1401 6 20.3763 29.1306 1.39291 -22.654 9.61717 24.1604 +1402 4 20.4714 29.8874 2.01179 2.99602 -8.49852 -9.62387 +1403 4 19.4639 28.7985 1.61052 22.0838 3.18086 -13.1329 +1404 6 50.878 13.1268 37.2744 -6.92527 18.9089 19.2141 +1405 4 51.431 12.5903 37.8743 -5.40112 9.96959 -2.47836 +1406 4 50.5327 13.8902 37.8162 10.8793 -23.2499 -13.6212 +1407 6 33.933 34.1706 20.4988 -24.935 23.2996 -4.02345 +1408 4 33.9537 34.3969 19.5503 3.97405 -5.2202 10.173 +1409 4 33.1424 34.6907 20.8306 20.6842 -17.0796 -4.50693 +1410 6 26.2139 28.0427 27.5441 -18.3219 -6.87449 2.92541 +1411 4 26.6233 28.4264 28.3298 2.52406 0.509022 -5.28732 +1412 4 25.2474 28.0355 27.7473 15.6982 -2.70826 -9.65401 +1413 6 7.68199 21.3044 4.2899 -23.4352 7.97399 30.3744 +1414 4 8.39223 20.9571 3.80392 40.3202 -21.1106 -20.5498 +1415 4 7.23721 21.8696 3.67656 -12.7303 12.1883 -10.427 +1416 6 21.997 15.1678 5.91921 0.156106 10.1967 -8.47357 +1417 4 22.4631 15.3078 5.09012 1.49736 10.8302 -2.43488 +1418 4 21.9323 14.2285 5.99467 -4.63281 -19.7734 10.7123 +1419 6 21.7161 24.0028 3.81129 14.7157 -6.77156 -2.79544 +1420 4 22.6514 24.278 3.99089 -16.266 -7.57571 -5.80044 +1421 4 21.7278 23.1773 3.27349 4.3704 10.7286 8.25651 +1422 6 11.5654 23.7677 12.5675 4.34126 23.9889 5.0328 +1423 4 11.8179 24.711 12.3772 -5.51197 -27.812 -0.203907 +1424 4 11.194 23.7871 13.4529 -2.51135 -1.17837 2.27349 +1425 6 32.365 18.0609 29.8133 5.42876 1.07285 10.0727 +1426 4 33.2855 17.8495 29.9872 2.18588 2.92383 8.75228 +1427 4 32.2516 17.686 28.9464 -9.45666 -7.03173 -17.6671 +1428 6 9.26057 12.3901 30.3108 6.69251 -5.93803 -6.45383 +1429 4 8.9331 13.0089 30.9751 -1.99931 -0.452864 0.983921 +1430 4 10.127 12.0766 30.6488 -15.6011 7.03664 -5.16285 +1431 6 40.1575 25.9297 9.14135 -21.3024 -7.39617 3.31146 +1432 4 40.7828 25.2448 9.36979 6.64832 -8.60816 0.262948 +1433 4 40.6901 26.6937 8.96671 10.3695 18.4246 -3.8085 +1434 6 43.1786 32.337 37.3292 -33.551 -18.2832 -9.28851 +1435 4 42.7165 32.8749 36.6701 14.8891 8.67062 4.46068 +1436 4 42.4294 31.7351 37.5575 24.0939 3.67107 5.33039 +1437 6 44.0961 6.28371 31.2632 9.51948 -8.69332 -33.5784 +1438 4 43.4914 6.92213 31.6058 -15.4833 19.2503 12.9198 +1439 4 44.559 5.89005 31.9835 8.76633 -8.79917 23.1113 +1440 6 10.2083 18.8859 19.6919 15.5822 -2.80816 -8.35433 +1441 4 10.2079 18.3466 20.4907 -1.18434 0.124911 0.125127 +1442 4 9.35433 19.315 19.665 -12.7717 3.54701 3.24565 +1443 6 7.05259 15.5816 15.0277 -11.6868 16.7681 -20.4125 +1444 4 7.21112 15.523 14.0697 -0.749561 -1.2692 3.08306 +1445 4 7.39122 14.7797 15.3874 7.84577 -24.8334 9.86289 +1446 6 24.5366 3.48359 27.8583 16.7503 5.69766 5.18976 +1447 4 23.7024 3.43271 28.3539 -4.73503 -2.50774 -10.2909 +1448 4 24.4259 3.10654 26.9763 -12.6917 -5.22111 2.5626 +1449 6 54.3931 31.8073 9.72289 -3.19054 17.1237 19.0803 +1450 4 53.9641 31.62 8.89214 -6.37727 -2.00813 -13.4715 +1451 4 54.1243 32.7301 9.92854 3.65429 -15.124 -2.64791 +1452 6 6.79493 17.0949 36.2025 -8.81624 7.47492 14.5397 +1453 4 5.9165 16.6466 36.2092 18.1356 5.91394 -12.2869 +1454 4 7.21103 17.1598 35.3293 -13.3551 -7.88765 -1.67162 +1455 6 28.633 7.46221 20.4165 -21.0133 14.9556 -29.8407 +1456 4 27.7506 7.6389 20.7846 4.83271 -6.12746 3.71795 +1457 4 28.5316 7.77661 19.4783 9.56717 -7.40103 22.9991 +1458 6 17.0376 1.7027 8.35788 5.34968 28.5352 32.0038 +1459 4 17.0661 0.753124 8.28199 -2.4228 -14.8367 -20.8379 +1460 4 16.762 2.22772 7.59129 -1.56258 -15.3605 -8.12812 +1461 6 19.1384 19.3343 35.5751 19.5023 3.30605 7.15282 +1462 4 18.4451 18.7061 35.4179 -10.2251 -8.92118 -4.92207 +1463 4 19.8852 18.808 35.914 -3.54436 4.66685 -0.605832 +1464 6 7.31639 31.3666 13.5695 -43.9944 -20.214 -21.2721 +1465 4 6.78612 30.574 13.8569 21.4883 17.7075 -0.698983 +1466 4 6.68503 31.7843 12.9295 22.0056 -0.349161 9.64417 +1467 6 16.674 5.24419 12.8556 -11.0373 -33.5815 5.02698 +1468 4 17.465 5.75961 12.9546 20.2971 3.5869 6.63236 +1469 4 16.7677 4.34295 13.2785 1.53127 21.9447 -10.2143 +1470 6 43.8803 12.7494 34.5747 -22.4085 -20.9808 -0.0671255 +1471 4 43.9515 13.6536 34.2548 -4.30422 8.76569 -3.51904 +1472 4 42.9542 12.429 34.42 18.6754 8.57765 -0.433924 +1473 6 42.6607 36.4569 28.5239 -16.8168 -12.4187 2.20896 +1474 4 42.172 37.2929 28.6321 13.9601 -3.78206 -4.91178 +1475 4 43.5913 36.5775 28.2923 4.62592 13.2896 -0.105187 +1476 6 35.3772 15.0586 6.04009 27.912 48.9275 -7.18458 +1477 4 35.887 15.8982 5.7897 -19.1126 -32.2788 12.1212 +1478 4 34.8045 14.9281 5.27735 -5.52923 -7.04807 -1.55591 +1479 6 19.4078 5.85855 6.1829 -40.2001 -18.9085 -3.31614 +1480 4 18.5441 5.99364 6.63156 8.43156 -9.10613 -8.3884 +1481 4 19.928 6.53616 6.54489 31.8426 31.4232 15.0663 +1482 6 29.261 38.1682 6.98131 -37.2303 32.1811 -6.57247 +1483 4 28.4837 38.0966 7.57517 15.5489 -1.40449 -6.41795 +1484 4 29.8842 37.5088 7.21603 19.671 -25.1607 10.5683 +1485 6 19.357 26.1782 8.47801 4.74765 -18.9961 17.9486 +1486 4 19.3733 25.7814 9.38274 -2.97831 10.6699 -17.265 +1487 4 20.1618 25.7953 8.09114 -4.76457 3.34604 0.730176 +1488 6 4.92328 16.6713 6.1398 7.47336 5.27851 2.26954 +1489 4 5.50113 17.3858 5.8203 -2.76896 -2.40075 1.51866 +1490 4 5.42288 15.8417 6.02573 -4.96937 12.5626 -0.560722 +1491 6 6.06184 16.6875 28.0703 25.9558 6.64688 1.10321 +1492 4 5.15824 16.4097 27.9597 -16.212 -5.66481 -14.185 +1493 4 6.48748 16.8231 27.1848 -21.9791 -6.00697 19.2504 +1494 6 21.7362 29.3702 22.1089 -17.2737 20.913 34.8846 +1495 4 21.4452 30.3289 22.1112 6.19611 -27.0689 0.469942 +1496 4 21.3293 28.9728 22.9428 14.5469 12.9694 -26.9427 +1497 6 24.4985 0.540505 12.8515 12.2489 -9.36427 2.95715 +1498 4 24.0437 0.939092 12.114 -3.50986 5.42614 -10.4761 +1499 4 24.1106 0.99496 13.5957 -0.561841 3.41965 12.163 +1500 6 18.4019 28.2584 40.3145 -11.401 19.5033 -15.6681 +1501 4 18.3886 27.6361 41.0165 -1.05122 -20.6036 22.2694 +1502 4 19.1831 28.024 39.826 8.23901 2.08545 -8.43276 +1503 6 10.3826 17.4565 21.9113 1.92941 -13.2413 3.45357 +1504 4 9.8824 16.6205 21.8349 3.82121 7.52813 2.02092 +1505 4 9.93899 17.9725 22.5913 -5.82795 2.16988 4.16556 +1506 6 13.5489 13.3588 39.6353 11.9209 29.8927 39.0415 +1507 4 13.8427 14.2544 39.3649 -8.64321 -16.3346 -3.85104 +1508 4 13.5548 13.4385 40.6332 -1.97454 -11.1079 -31.9482 +1509 6 19.5449 26.0093 24.7389 -52.2633 13.2593 -7.73686 +1510 4 19.57 25.3975 24.0097 10.2262 -10.7296 -10.4349 +1511 4 20.3304 26.0184 25.2393 35.6126 -10.3894 17.1361 +1512 6 8.93096 25.8929 20.0882 -7.71251 -64.4566 3.30388 +1513 4 8.30787 26.3938 20.5887 -11.4685 32.8171 11.63 +1514 4 9.62246 26.3511 19.648 20.7791 34.2926 -13.3665 +1515 6 13.4555 41.2072 30.5108 -10.8988 -15.928 5.69795 +1516 4 14.2767 41.1294 31.0436 -12.4449 -5.39064 -3.38157 +1517 4 12.7718 40.5451 30.8276 25.6688 18.9533 -5.69319 +1518 6 21.165 21.6707 11.1126 6.53241 11.8742 3.94385 +1519 4 20.8889 20.8699 10.6872 -6.5221 -17.8932 -11.6656 +1520 4 21.171 21.4318 12.0451 -0.673303 -0.892159 6.0991 +1521 6 43.5659 10.3222 15.565 -2.18625 -17.2881 -4.53442 +1522 4 43.269 9.50121 15.139 10.696 3.36153 7.59808 +1523 4 42.8911 10.937 15.2983 -10.0921 17.3133 -0.93945 +1524 6 23.5255 5.06673 12.3063 -8.27451 55.1521 -7.02327 +1525 4 23.4703 4.15364 12.096 -5.93718 -33.8878 -14.7403 +1526 4 23.077 5.57318 11.5535 15.1023 -26.9196 22.8331 +1527 6 9.29314 15.4001 4.25145 -3.86255 -4.02248 -25.5662 +1528 4 8.9509 16.1187 4.78154 1.1615 8.22379 13.6068 +1529 4 9.97933 14.9549 4.74249 8.84801 0.0887981 11.7331 +1530 6 26.7067 10.8779 17.5788 3.55047 -19.7627 -22.9275 +1531 4 26.5537 10.995 18.4988 -3.13636 8.79354 30.8805 +1532 4 26.79 11.729 17.1566 -1.16375 6.51516 1.16674 +1533 6 26.0497 23.6027 33.6801 19.5894 25.2732 20.1931 +1534 4 25.4452 23.9936 33.0304 1.52608 5.68176 -1.06817 +1535 4 26.6384 24.3139 34.1277 -30.0139 -24.8801 -23.6693 +1536 6 7.5709 10.5028 28.9083 -0.962228 -19.583 -21.6711 +1537 4 6.74329 10.4799 29.4005 3.80738 8.46019 8.36633 +1538 4 8.19878 11.0832 29.3397 0.629116 8.24646 12.7121 +1539 6 16.498 16.9072 24.6485 7.82025 23.6222 16.3151 +1540 4 16.0345 17.7596 24.5588 5.31695 -3.73313 -0.390286 +1541 4 16.1792 16.4208 23.9083 -7.11448 -16.9587 -21.9433 +1542 6 12.549 12.7866 0.448591 8.35618 6.39845 34.9671 +1543 4 12.9768 12.9146 1.38779 -15.5602 -17.6496 -50.0052 +1544 4 12.7689 11.9205 0.0349689 0.659473 7.36742 13.3893 +1545 6 6.80731 2.45617 9.05869 -7.23501 -7.03372 -0.578084 +1546 4 7.10343 3.02287 9.78944 7.77528 -6.31722 -2.26682 +1547 4 7.3272 1.63733 8.99034 2.01029 5.74015 6.94656 +1548 6 28.8877 11.8706 12.0154 41.6386 34.6329 -2.99516 +1549 4 28.2108 12.4771 11.6895 -6.34049 1.49886 1.56166 +1550 4 29.7533 12.3393 11.8008 -29.7579 -18.4108 8.17464 +1551 6 44.6745 32.5962 29.7139 -34.2161 4.66467 6.73964 +1552 4 43.7628 32.9784 29.4642 35.9402 -16.1761 10.2258 +1553 4 44.5125 31.9002 30.3967 -1.3182 18.2082 -15.8911 +1554 6 28.5995 15.1068 32.2872 13.2766 -51.3111 -20.1848 +1555 4 29.0279 15.8582 31.8991 2.31019 19.0875 -3.40369 +1556 4 29.0943 14.3419 31.8537 -21.7517 23.8731 20.1718 +1557 6 1.14062 22.1898 33.6289 -39.3586 14.574 19.5436 +1558 4 0.65227 22.798 33.0535 3.91391 -2.7929 6.08546 +1559 4 1.82717 21.8879 33.088 34.4042 -16.5957 -27.8984 +1560 6 17.4513 16.8201 9.93098 -1.82085 -23.3459 26.2514 +1561 4 17.8906 17.1746 9.18159 7.86355 15.3521 -22.135 +1562 4 18.0267 16.0779 10.2085 -7.73246 7.19916 -1.96586 +1563 6 18.7435 29.8048 14.4095 21.7061 -3.72347 40.0221 +1564 4 19.5652 29.5706 14.9087 -19.4331 3.67999 -8.42588 +1565 4 18.9661 29.6909 13.4944 1.97037 -1.23698 -19.2163 +1566 6 39.4071 6.51101 13.0179 12.0574 6.81682 -11.0022 +1567 4 39.7785 7.30288 12.5709 -10.193 -11.7897 7.6563 +1568 4 39.9532 5.78104 12.6849 -4.03584 4.98089 5.48617 +1569 6 54.0977 38.2821 14.3159 8.76467 -13.509 23.2458 +1570 4 53.5116 38.6447 15.0061 0.0542658 1.01747 -18.4972 +1571 4 53.8554 38.6311 13.4594 -12.9742 11.219 -5.93773 +1572 6 7.52036 32.013 20.9427 34.362 14.2167 21.5407 +1573 4 7.05735 31.9924 20.1252 -18.8869 -6.37038 -21.2822 +1574 4 7.04171 31.4816 21.5607 -16.1882 -11.3569 11.099 +1575 6 26.965 15.5039 13.8257 -10.8147 -22.3452 14.7237 +1576 4 27.2177 14.7358 14.3683 8.65177 6.42067 -5.59001 +1577 4 26.0429 15.6169 14.0906 -6.80859 9.66341 -6.51148 +1578 6 18.3782 16.4473 32.1249 -4.95226 -1.86998 -9.87987 +1579 4 18.1426 16.6374 31.1969 4.73263 -0.719504 8.39792 +1580 4 19.0836 17.0573 32.3614 6.73072 6.57595 -2.73442 +1581 6 52.4873 31.678 23.2415 -44.1119 -6.58328 47.4356 +1582 4 52.4708 32.2686 24.0415 7.23299 -8.75358 -21.8316 +1583 4 53.1739 31.883 22.645 31.3465 14.6123 -23.9869 +1584 6 2.16824 9.71317 28.2162 5.46837 -18.1801 7.45826 +1585 4 2.48183 10.5213 27.7929 -7.61484 8.72751 3.65687 +1586 4 1.37959 9.87032 28.768 3.44281 10.2362 -4.06622 +1587 6 32.9194 0.0905733 22.5781 10.5432 -20.5017 -7.42813 +1588 4 33.2395 41.1185 22.3208 -17.3926 6.61176 1.08087 +1589 4 33.7441 0.505918 22.8191 5.29332 16.1982 3.6992 +1590 6 20.7309 41.5697 38.6372 28.3147 -14.9122 -44.687 +1591 4 20.0328 41.0591 39.0281 -13.7779 -1.58578 11.2509 +1592 4 21.0348 40.9602 37.8857 -7.98591 29.4899 32.1121 +1593 6 43.3035 24.332 12.1458 11.7575 -1.61212 -4.71191 +1594 4 43.2118 25.2792 12.3722 8.64503 -11.1136 -9.01316 +1595 4 44.1249 24.1975 11.6011 -17.6772 13.9566 14.4164 +1596 6 22.028 36.2965 11.8178 -12.5217 11.0116 -6.64335 +1597 4 21.6755 36.9888 11.229 7.35556 -7.61462 10.605 +1598 4 22.8593 36.0261 11.4203 4.02803 -2.23458 -0.408194 +1599 6 50.7458 20.5312 30.3336 -27.3371 19.0798 0.575242 +1600 4 50.2829 20.0188 31.024 4.3389 0.549123 -5.17754 +1601 4 50.1148 21.2814 30.1453 20.3707 -20.1638 4.65154 +1602 6 20.8352 3.85006 18.1924 -4.58005 6.82859 16.651 +1603 4 21.6331 4.17131 17.7775 4.55578 1.29171 -4.07778 +1604 4 20.7516 4.34878 19.0287 -0.852135 -6.30171 -7.97465 +1605 6 4.00732 20.6422 6.98905 -51.5603 -31.2986 19.6291 +1606 4 3.1116 20.4695 6.56725 35.2765 12.481 -1.34365 +1607 4 3.83148 20.2497 7.8921 17.5771 16.9916 -21.2359 +1608 6 11.9503 15.4361 41.4392 2.8915 -19.3712 8.63656 +1609 4 11.9967 14.4718 41.7234 3.98465 29.7679 -14.4511 +1610 4 12.4631 15.5787 40.6176 -3.08486 -9.43894 7.49139 +1611 6 3.00006 18.5443 38.9307 7.29951 -23.84 25.6029 +1612 4 3.57591 17.7463 38.8471 -9.50595 12.5214 2.28144 +1613 4 2.93408 18.9335 38.0756 -3.85177 13.2219 -26.1975 +1614 6 8.60604 38.8696 11.3027 41.4164 30.2615 0.48057 +1615 4 9.41419 39.0226 10.7506 -16.8144 -5.25469 8.62565 +1616 4 8.21901 38.0768 10.9944 -17.9318 -38.1368 -15.4555 +1617 6 12.9777 33.9736 38.4849 13.2116 9.7409 3.49313 +1618 4 12.6169 33.1824 38.0476 12.8065 1.18326 0.516457 +1619 4 13.9558 34.0654 38.367 -20.6967 -9.66923 -0.235313 +1620 6 4.68265 11.9882 6.05233 -5.36104 -17.6375 -21.4001 +1621 4 3.82121 11.6194 5.80881 -7.3972 4.97776 10.103 +1622 4 5.22981 11.6659 5.30604 -0.806592 6.4598 12.5779 +1623 6 10.8388 15.9226 25.2234 -25.8257 0.885817 -3.68505 +1624 4 11.7194 16.2357 25.361 23.5714 9.8582 3.12124 +1625 4 10.3656 16.637 24.773 5.49819 -5.38784 0.449897 +1626 6 20.7519 3.25216 6.54608 14.2232 16.6176 4.63006 +1627 4 20.286 2.47445 6.25961 -10.3965 -11.4853 -2.16446 +1628 4 20.1859 4.03183 6.47283 -6.25253 -2.40724 -3.99784 +1629 6 47.6296 39.155 31.2075 -6.94169 16.2372 -29.2685 +1630 4 46.6717 39.1522 30.9686 19.778 5.05469 4.61154 +1631 4 48.0746 39.7923 30.5789 -18.3255 -25.0069 20.1215 +1632 6 8.32942 27.7692 27.6861 -22.9675 10.5768 13.2964 +1633 4 7.92083 27.0814 28.2574 8.55111 11.2092 -8.24047 +1634 4 9.05389 27.3382 27.2479 10.5137 -11.4359 -5.41666 +1635 6 33.26 40.3166 33.4176 17.9089 -0.14465 -4.13778 +1636 4 32.5337 40.9457 33.2593 10.2249 -4.59604 -5.86803 +1637 4 34.0027 40.4737 32.781 -17.2015 3.54767 8.86095 +1638 6 24.5063 34.6298 27.2698 0.491312 8.45089 -9.78892 +1639 4 24.8706 35.531 27.0561 -9.74802 -22.5685 0.190878 +1640 4 24.1 34.2837 26.4337 10.8101 11.1551 19.1745 +1641 6 13.3248 36.7606 35.7302 31.7841 1.54421 8.12469 +1642 4 14.2215 36.6075 36.119 -13.0291 10.9369 -8.07597 +1643 4 12.8242 36.0333 36.0767 -19.6956 -11.898 1.78685 +1644 6 34.0654 20.1519 33.2169 18.328 45.6356 -7.38724 +1645 4 34.7846 20.5927 32.7056 -13.2567 -20.8909 7.62801 +1646 4 33.6055 20.9496 33.5712 -4.62613 -21.3045 2.82084 +1647 6 22.8301 33.56 31.6141 4.86266 11.3389 -12.2002 +1648 4 23.5774 34.1707 31.5466 -2.83601 4.36281 -5.03091 +1649 4 23.1188 32.9172 32.2538 0.234413 -13.6868 11.6365 +1650 6 23.7437 2.42751 19.8437 5.37542 22.288 12.015 +1651 4 24.549 1.92657 19.7151 11.8542 -9.34304 -3.08207 +1652 4 23.0522 1.96699 19.3939 -17.1839 -15.7883 -12.7178 +1653 6 10.5922 1.64055 20.5239 -11.6119 -4.18685 -4.47424 +1654 4 10.0475 0.976152 20.0603 6.63037 0.339841 6.84259 +1655 4 10.5 2.45781 20.009 1.22375 1.55874 1.33627 +1656 6 6.49834 24.8637 7.80908 13.1619 -16.462 -27.2261 +1657 4 7.39752 24.8711 7.42138 -7.39511 8.18905 12.026 +1658 4 6.07255 24.1767 7.26903 -7.5733 6.7583 6.8074 +1659 6 54.7892 32.5297 25.4757 -1.36407 18.5665 -18.8778 +1660 4 54.0312 33.1434 25.3693 10.0694 -13.7478 6.1371 +1661 4 0.333918 32.6202 24.6425 -12.8409 -6.42816 22.883 +1662 6 6.2467 20.1884 28.9797 -14.5872 3.94595 -2.55046 +1663 4 5.42154 20.1642 28.4577 8.07739 1.90281 8.6477 +1664 4 6.84484 19.6236 28.4838 10.3646 -4.74821 0.341067 +1665 6 50.0565 21.6117 11.3373 -2.04109 28.5423 -29.4123 +1666 4 50.95 21.7264 10.9878 2.40449 3.31798 -5.14809 +1667 4 50.1463 20.9073 11.9368 0.900865 -33.3483 27.1981 +1668 6 43.4794 33.5181 19.6392 10.2306 -3.22473 -8.26676 +1669 4 43.7308 33.5714 20.5426 20.9097 -0.172793 18.6354 +1670 4 42.5556 33.6283 19.7345 -31.1875 3.87355 -8.92325 +1671 6 30.8203 7.18413 41.0653 -47.5647 29.7584 13.5959 +1672 4 29.9879 7.63165 40.681 33.629 -21.8567 10.9994 +1673 4 30.7637 7.50249 0.10761 7.36747 -14.0232 -31.1296 +1674 6 12.1328 25.8622 11.0863 -33.3162 -17.1307 -4.35232 +1675 4 11.2035 26.0164 10.7385 31.652 5.74526 10.6132 +1676 4 12.7063 26.6022 10.9281 7.22016 21.1466 -6.88425 +1677 6 47.8272 5.81934 17.7377 34.4122 -10.5063 -19.6374 +1678 4 48.0885 5.28838 16.9377 -7.84164 17.03 17.5567 +1679 4 48.6906 6.1712 18.0872 -20.5621 -5.0871 -4.09565 +1680 6 35.1646 12.9005 16.5891 -8.94037 2.15609 -8.82704 +1681 4 35.428 13.0005 17.5199 -6.39768 8.78744 -5.13392 +1682 4 34.5308 13.6301 16.3523 17.2323 -15.7422 12.9621 +1683 6 10.4611 10.6156 33.9687 -31.8989 -9.58391 14.7288 +1684 4 10.7981 11.3375 34.5166 5.24051 -2.75865 -7.26377 +1685 4 9.62118 10.4004 34.4306 17.5569 -1.50819 -12.473 +1686 6 9.86916 7.4616 9.67483 -1.17411 0.415312 -19.5192 +1687 4 9.17172 8.12646 9.7346 0.921409 2.8109 10.1471 +1688 4 9.97058 7.3459 8.70248 1.1017 -0.154201 19.4763 +1689 6 11.1489 9.5612 29.1408 -3.50418 -13.4139 2.93109 +1690 4 10.6848 9.26325 29.9428 4.68224 5.10434 -5.79998 +1691 4 11.3989 8.73954 28.6776 0.998479 5.88331 1.3781 +1692 6 46.4028 12.7539 37.8993 8.34964 0.221 -8.93676 +1693 4 46.6625 12.9969 36.9769 -3.46511 -1.57209 17.4302 +1694 4 46.8246 13.3669 38.5286 -1.63466 -3.53539 -5.22058 +1695 6 4.76485 19.028 16.0085 -13.5875 12.8334 -9.71245 +1696 4 4.2246 19.0797 16.8211 14.4547 -7.44532 -2.23877 +1697 4 5.5965 18.5831 16.2078 1.83868 -2.3176 10.3072 +1698 6 50.2593 39.8135 19.3633 -11.209 7.32279 -16.1387 +1699 4 50.2357 39.0929 20.0186 -9.83071 -0.813057 -10.1916 +1700 4 49.5811 39.7404 18.6324 20.3589 -6.83946 23.6454 +1701 6 3.57863 23.2976 26.309 -19.8478 3.89203 -2.42552 +1702 4 2.95325 23.1663 25.5593 11.1236 -1.69658 12.5574 +1703 4 3.09228 23.9147 26.9028 8.7219 -10.8877 -9.85517 +1704 6 43.325 18.2347 20.509 -6.81505 -1.42332 -3.46621 +1705 4 42.8171 19.0284 20.7204 1.20306 1.51529 1.23812 +1706 4 43.8577 18.0426 21.2915 2.12676 -2.58083 4.4502 +1707 6 14.5031 41.5275 19.7277 -3.40329 -5.13047 -40.8094 +1708 4 13.9246 41.7804 20.437 0.184992 5.83632 25.1113 +1709 4 15.42 41.4218 19.9774 10.3149 -1.62678 14.571 +1710 6 29.2836 29.8681 26.9083 14.7251 3.00272 -32.0725 +1711 4 29.2754 29.741 25.8744 6.18055 14.2787 56.2455 +1712 4 30.1283 30.2623 27.2985 -22.384 -15.5718 -22.4063 +1713 6 6.3217 26.153 11.5726 -10.9318 2.11689 -6.65038 +1714 4 6.21736 25.7454 12.4421 7.16784 6.77942 9.71283 +1715 4 6.96084 26.8819 11.5675 -0.124344 -5.20772 8.78036 +1716 6 27.6636 9.22988 15.2432 27.2347 15.0341 -6.49447 +1717 4 28.4103 9.83484 14.9873 -20.1055 -14.3916 8.85848 +1718 4 27.7674 8.48088 14.6445 -1.45999 -3.40178 1.02673 +1719 6 29.7804 38.0662 17.0819 -1.94795 -3.59677 -9.66723 +1720 4 29.6031 37.2203 16.6025 -2.55573 18.1678 4.54076 +1721 4 29.1155 38.7497 16.8561 3.55432 -16.3657 1.57327 +1722 6 52.2257 28.7184 4.26028 43.5541 11.735 -13.9492 +1723 4 53.1498 28.7813 3.86382 -28.9168 1.3453 15.0129 +1724 4 51.9642 27.8111 4.13511 -4.98861 -18.1961 -3.0857 +1725 6 17.1716 16.6708 6.09349 0.800403 22.8617 11.3476 +1726 4 16.9906 17.4665 6.64994 5.32834 -8.85643 -15.9231 +1727 4 16.9912 15.9587 6.69883 -0.0606397 -19.1034 5.18453 +1728 6 36.6551 7.54529 33.4256 0.520164 -21.8515 26.6937 +1729 4 35.9994 7.02185 33.9501 8.71508 10.7979 -12.9224 +1730 4 36.139 7.85703 32.6949 -12.9525 8.58568 -17.7829 +1731 6 26.1712 3.13186 9.59195 18.1066 21.2961 -28.5304 +1732 4 26.5502 3.5196 10.357 16.0028 12.4994 23.003 +1733 4 25.6506 2.45477 9.93435 -32.3265 -38.1289 14.2303 +1734 6 1.19956 17.1196 33.1708 -2.2935 18.3305 -9.07621 +1735 4 1.01553 17.8006 32.4822 1.56489 -10.8534 12.1427 +1736 4 0.844206 17.4429 34.0214 2.04572 -1.59411 -6.06332 +1737 6 29.1739 10.178 5.37516 -2.40587 -18.3881 11.7134 +1738 4 28.5386 10.354 6.08377 0.376669 4.93981 -3.98875 +1739 4 29.4881 9.26834 5.54278 -5.29161 7.67482 -7.40705 +1740 6 9.22817 21.1342 0.188585 30.2393 3.90367 9.01386 +1741 4 10.0008 20.6689 41.6954 -19.6386 2.89796 1.05729 +1742 4 8.40981 20.8027 41.7407 -2.68979 -7.66638 -7.21336 +1743 6 7.42006 26.8879 34.8536 3.14545 16.5486 30.4349 +1744 4 7.04622 27.0927 35.7464 10.1233 -6.04195 -26.4158 +1745 4 6.87255 26.19 34.5186 -13.4343 -18.5802 -10.0193 +1746 6 18.6153 10.1647 3.02259 -21.2705 37.3854 6.86975 +1747 4 17.9982 9.42011 2.89287 2.11135 15.8633 3.52195 +1748 4 18.115 11.0437 3.25865 19.508 -44.5053 -11.6159 +1749 6 13.1266 21.2208 25.207 -7.78894 4.80204 -7.88194 +1750 4 12.927 21.6586 24.3646 3.95449 -7.72121 4.87382 +1751 4 12.8054 20.3208 25.1571 -2.69895 -8.80511 -3.48609 +1752 6 4.90585 24.4116 40.531 -24.4864 -14.2944 -35.1794 +1753 4 5.64285 24.6041 41.0938 21.6142 3.21823 7.1591 +1754 4 5.22115 23.997 39.6806 -3.1008 12.4445 27.1665 +1755 6 54.7234 6.29054 9.93868 16.9838 3.76988 -11.4262 +1756 4 54.1595 6.0167 10.6465 -16.0707 -8.53288 16.3243 +1757 4 -0.00708757 7.17696 10.1972 2.88265 8.42125 0.296955 +1758 6 51.7481 16.6603 19.3703 -0.380283 5.87397 -29.4424 +1759 4 51.6376 16.2748 18.4816 -6.94363 -1.60509 11.109 +1760 4 52.3909 17.3585 19.2003 6.35466 6.30558 5.78841 +1761 6 38.6244 2.9738 13.1093 11.8256 2.30897 44.7329 +1762 4 38.5518 3.44318 13.9917 -0.399232 -9.9856 -23.4333 +1763 4 38.2423 3.54447 12.4592 -11.1085 17.5319 -17.0773 +1764 6 19.4422 35.7095 9.59568 3.40577 -0.828385 -4.73593 +1765 4 18.7414 36.105 9.07989 -9.16576 -3.00828 -7.06541 +1766 4 19.0009 35.4265 10.4088 3.97598 4.46758 -4.25365 +1767 6 46.943 37.6271 25.6985 10.3793 1.77648 -5.56802 +1768 4 47.12 37.9785 24.823 -9.34628 8.6078 -10.4475 +1769 4 47.7536 37.1497 25.8683 2.27046 -5.59472 9.98269 +1770 6 20.0359 17.269 14.7493 3.99527 -1.04076 21.685 +1771 4 19.226 17.5112 15.2169 -1.54973 1.23777 -13.9596 +1772 4 20.6203 17.0021 15.471 1.89523 -0.789097 -10.2839 +1773 6 24.7462 29.2867 3.75843 -10.1451 -8.18783 10.4774 +1774 4 24.6712 28.3277 3.51733 13.2212 23.8029 -9.5704 +1775 4 25.3186 29.8222 3.19111 0.258423 -15.3949 -10.1904 +1776 6 3.43 8.91865 6.82525 30.9316 4.78471 42.1024 +1777 4 3.12906 8.84201 7.76799 3.51474 0.65101 -30.0512 +1778 4 4.4001 9.15772 6.93718 -35.8795 -6.21414 -10.2854 +1779 6 17.4867 30.5875 19.7089 25.363 -13.1809 -11.8275 +1780 4 18.4189 30.3609 19.3993 -33.7851 8.31766 10.936 +1781 4 16.9116 29.8624 19.4038 1.038 7.7974 -2.73085 +1782 6 13.2718 16.1862 39.0546 8.76191 -18.4723 6.03369 +1783 4 13.8233 16.8904 39.4031 3.30361 7.54485 1.72389 +1784 4 12.5422 16.5765 38.5789 -11.7633 13.4881 -8.40344 +1785 6 23.832 27.9756 11.5898 -7.03122 5.38421 -2.05105 +1786 4 23.0756 27.4469 11.9259 8.81977 12.3317 -3.01362 +1787 4 23.7182 28.9056 11.8688 -5.28793 -12.9553 -0.41204 +1788 6 14.4579 24.426 21.2343 -3.66896 12.863 -1.79834 +1789 4 13.9584 25.2806 21.2855 7.33453 -15.5065 2.73981 +1790 4 14.2661 23.9117 22.0367 -3.91682 9.90798 -0.991428 +1791 6 46.6073 15.1543 22.2965 -20.8333 -3.77381 -11.8272 +1792 4 45.9584 14.6421 21.811 -6.87655 -3.95362 10.1018 +1793 4 47.2458 15.2644 21.6001 24.1162 10.8017 0.759212 +1794 6 19.1409 29.7195 11.8497 24.0494 -34.2428 10.0272 +1795 4 18.8784 30.5975 11.5793 -19.1418 4.86007 -17.3781 +1796 4 18.6106 28.9994 11.4276 0.263541 23.8948 1.0376 +1797 6 36.9127 18.8084 27.6222 -22.9356 -21.6011 26.171 +1798 4 36.4352 18.471 26.8408 6.36827 4.7914 5.64024 +1799 4 36.536 18.2194 28.3533 14.6987 24.2872 -28.1415 +1800 6 35.8684 17.5378 25.4906 20.6945 -0.513689 -30.4481 +1801 4 36.5966 17.7728 24.866 -15.8574 8.27186 11.6809 +1802 4 35.9779 16.5759 25.48 -10.902 2.42848 10.2606 +1803 6 8.03691 41.9141 31.5248 13.0394 10.4535 -6.8036 +1804 4 8.57921 41.2412 31.9888 -13.1962 14.522 -11.1095 +1805 4 8.63283 0.684743 31.1326 -8.3799 -15.4286 7.32752 +1806 6 31.7059 34.8342 17.9371 1.99631 -25.0047 -8.79133 +1807 4 32.5911 34.4609 17.7211 -13.4776 12.334 6.09844 +1808 4 31.8527 35.7258 18.2497 13.1847 15.6537 3.27409 +1809 6 22.1093 41.055 5.1451 11.5479 29.9587 -53.8497 +1810 4 22.1004 40.5969 5.93279 -2.68624 -33.8843 55.363 +1811 4 22.7885 40.6204 4.60559 -4.38419 0.844423 3.37931 +1812 6 11.6153 5.16618 29.5584 -27.6475 13.1782 12.6346 +1813 4 12.1606 4.37097 29.6057 -8.91967 -2.9702 4.15115 +1814 4 10.7377 5.1092 30.0631 35.581 -10.2726 -16.0904 +1815 6 13.0239 9.45481 21.0754 -25.8377 -26.1508 -25.9824 +1816 4 13.6778 9.97234 21.4999 31.652 16.6928 15.5055 +1817 4 13.4195 8.72209 20.5617 -0.589626 12.3395 6.44381 +1818 6 12.4227 4.1736 0.163828 29.6522 45.8695 -12.8421 +1819 4 12.6651 3.77524 1.00427 0.341759 -1.42745 2.51987 +1820 4 13.0617 4.97102 0.020112 -31.9214 -41.0145 4.8633 +1821 6 45.168 14.6284 28.1023 4.783 -10.4532 13.0266 +1822 4 45.253 14.8969 27.1759 8.39119 -6.85383 -0.732919 +1823 4 45.9575 14.0916 28.3529 -13.3622 13.2892 -14.7888 +1824 6 52.571 19.2551 0.894665 -6.12931 -19.318 2.27414 +1825 4 52.6102 19.199 41.8388 0.592413 0.00811024 1.08479 +1826 4 52.8129 20.1442 1.11528 6.55776 18.4237 2.43046 +1827 6 0.161625 18.5694 30.5785 -3.0227 0.535636 4.36465 +1828 4 0.968981 18.7291 30.0798 6.18464 -7.16445 -2.53371 +1829 4 54.7907 19.4514 30.677 -10.8229 5.89199 6.00525 +1830 6 17.6528 28.1849 1.96402 -7.28907 9.7522 11.2687 +1831 4 16.9769 28.8628 1.74785 9.23997 -9.27082 -2.31394 +1832 4 17.6006 28.1534 2.93661 3.56557 1.38454 -8.44201 +1833 6 22.5099 30.1653 5.01109 -1.02808 20.8676 -0.473944 +1834 4 23.1753 30.1014 4.30975 -2.49536 -9.56192 4.09657 +1835 4 22.058 29.3206 5.04766 -1.45363 -6.71999 -4.50103 +1836 6 11.4023 8.80853 17.6459 -26.9993 9.53928 -4.75555 +1837 4 11.8645 8.1762 18.2108 15.3222 4.18532 1.52515 +1838 4 11.9865 9.48216 17.2519 4.47877 -12.4161 10.2871 +1839 6 32.2917 3.59674 26.8117 35.3382 32.7507 -4.14644 +1840 4 31.8458 3.34967 26.0065 -10.4154 -4.5889 -14.8452 +1841 4 32.8806 4.37505 26.5671 -21.1848 -26.3524 0.379863 +1842 6 26.835 37.1568 15.6529 -0.874066 14.8773 29.2405 +1843 4 26.7488 37.4766 16.567 0.376185 8.65421 -15.6923 +1844 4 26.6891 36.2303 15.7909 -0.851881 -23.4278 -14.9094 +1845 6 22.9473 3.40289 22.286 14.7574 -3.5158 -4.23343 +1846 4 23.2792 2.98888 21.4515 -4.53852 7.92848 16.4552 +1847 4 23.7307 3.68139 22.8048 -11.9145 -5.32443 -10.4265 +1848 6 14.6269 28.2214 5.19572 6.06687 6.51489 2.87291 +1849 4 14.1454 28.1555 4.36712 -3.39073 -3.27129 -8.45242 +1850 4 14.2747 28.9991 5.64824 0.61258 -1.12864 1.62503 +1851 6 20.2538 37.2031 16.5466 -28.2562 5.81675 18.2866 +1852 4 21.1004 37.4666 16.2032 21.0823 8.59207 -3.85991 +1853 4 20.0754 37.7549 17.3418 4.82626 -5.93036 -10.2325 +1854 6 17.9544 28.5616 23.889 16.4449 -8.57642 -4.83649 +1855 4 18.808 28.1928 23.5683 -20.3084 2.86715 8.85187 +1856 4 17.2559 27.9215 23.6535 6.51898 5.694 -2.26134 +1857 6 33.646 24.2349 25.2286 -4.54069 1.10679 -14.8717 +1858 4 33.6591 23.269 25.0602 3.54988 10.512 10.2941 +1859 4 34.0237 24.3938 26.1034 0.864522 -9.38336 -2.59148 +1860 6 9.98122 17.6138 2.21344 7.43797 -27.5786 -7.49496 +1861 4 10.832 17.5317 1.73219 -10.6429 3.93943 7.97636 +1862 4 9.86311 16.7639 2.69719 0.409905 15.8492 -4.6087 +1863 6 24.3357 36.801 8.92185 2.98992 -6.60779 12.1866 +1864 4 24.0742 37.6409 8.56425 -5.30422 15.3919 -5.44039 +1865 4 24.7315 37 9.77917 -2.43549 -6.6012 -3.30269 +1866 6 14.4004 4.29557 27.7519 47.583 -3.32523 5.14754 +1867 4 15.335 4.40276 27.3948 -30.4143 -4.44284 13.8265 +1868 4 13.81 4.42145 27.0177 -13.2435 3.17509 -11.8406 +1869 6 13.214 25.4576 35.3169 -22.1271 -24.6319 4.29258 +1870 4 13.1587 25.1592 36.2444 11.1778 9.47444 -6.90086 +1871 4 12.4637 24.9943 34.8985 11.1514 12.2923 -1.08233 +1872 6 43.7301 33.1781 24.4042 -1.93578 -20.5981 16.0744 +1873 4 44.3223 32.959 25.1725 -10.0543 8.3706 -19.7015 +1874 4 44.0713 33.9344 23.9169 6.22405 5.02536 3.22562 +1875 6 6.9686 30.4099 7.14637 29.0056 7.39031 21.9321 +1876 4 6.75777 29.9621 7.98042 -5.17066 0.417247 -5.37485 +1877 4 6.23168 30.2842 6.57126 -23.4728 -6.8193 -11.7975 +1878 6 44.4308 39.4237 21.7855 -4.33275 0.914597 7.54549 +1879 4 43.8654 38.932 21.1541 10.179 9.64354 2.62582 +1880 4 45.001 40.0603 21.3196 -6.51882 -12.4268 -7.79327 +1881 6 1.18424 16.4398 24.9903 -32.4903 25.5998 2.59769 +1882 4 0.976951 16.9992 24.2076 17.4753 -17.2203 8.72915 +1883 4 0.385168 16.6115 25.5394 23.4019 -14.126 -4.16352 +1884 6 8.17355 33.8284 10.6836 -2.7688 -6.92624 14.1509 +1885 4 8.34263 33.4451 9.83813 20.7133 -1.8248 -25.0865 +1886 4 7.32622 33.4212 10.8229 -22.0824 -0.650197 20.9959 +1887 6 45.3734 15.866 40.492 8.57481 -12.1553 -4.93844 +1888 4 44.519 15.6937 40.0698 -0.240559 4.546 7.41406 +1889 4 45.2892 16.6061 41.0987 -5.95018 0.957053 0.609678 +1890 6 38.79 4.28815 15.8976 0.37918 -2.10791 -10.8791 +1891 4 39.6838 3.98516 16.099 -1.14178 2.00828 6.51653 +1892 4 38.4576 4.71748 16.7012 5.69678 -4.45181 -3.36891 +1893 6 21.0946 9.20757 23.9781 -15.5567 7.8487 -28.256 +1894 4 20.9171 8.74785 23.1381 12.0597 -4.77706 12.6228 +1895 4 20.522 9.98378 23.8483 8.03519 -2.74416 16.612 +1896 6 6.47513 36.1489 20.0112 1.62078 -0.443995 1.26518 +1897 4 5.91587 35.3892 19.7749 1.1588 6.62155 -0.72477 +1898 4 7.29927 35.7814 20.3561 -3.99682 -1.77997 -1.59627 +1899 6 17.7466 23.4563 11.2529 28.5847 -29.2717 26.027 +1900 4 17.0283 23.9723 10.9251 -27.3158 17.875 -1.49359 +1901 4 17.6201 23.2782 12.2162 -8.22502 9.28058 -23.7318 +1902 6 2.23619 39.2644 23.5388 49.8561 -28.1857 -22.6679 +1903 4 2.97831 38.9599 24.1359 -27.9038 8.524 -11.8523 +1904 4 2.61824 39.0932 22.6246 -22.7997 11.7085 33.9524 +1905 6 21.7216 10.3211 3.08421 -18.2449 14.4951 30.0936 +1906 4 21.8041 10.0076 2.215 15.0715 -18.3252 -42.7176 +1907 4 20.7597 10.3501 3.18369 2.1836 1.89441 6.77029 +1908 6 13.3346 37.6456 26.8309 31.2085 -13.7023 -2.95714 +1909 4 12.8405 36.9633 27.2803 -9.16641 -7.21061 8.74396 +1910 4 14.167 37.1703 26.5501 -23.1686 18.0804 4.61389 +1911 6 45.6739 9.85296 8.82966 10.4005 6.57186 1.33947 +1912 4 45.3411 9.70411 7.93855 -5.0879 -2.60549 -0.62074 +1913 4 45.1871 9.30295 9.44221 -8.90854 -6.98805 -1.17873 +1914 6 39.813 32.3454 29.581 6.89703 -12.1014 5.95535 +1915 4 39.6485 31.4219 29.3549 -7.08038 -1.01192 -10.7476 +1916 4 40.3223 32.2375 30.3827 0.600223 8.34958 5.32896 +1917 6 39.1399 32.1558 8.97291 22.8595 -6.45003 -40.3239 +1918 4 39.6086 32.0592 8.09926 -10.5081 2.64219 35.3633 +1919 4 38.2198 32.2158 8.71089 -7.955 1.72328 8.07951 +1920 6 29.7568 11.3071 40.3305 36.1908 -28.2332 -10.1569 +1921 4 29.0987 10.6276 40.5022 -6.8613 -0.261357 1.73371 +1922 4 30.5966 10.7518 40.2867 -25.0211 23.0598 -1.19829 +1923 6 24.8367 19.8778 29.8512 -3.76004 22.8831 22.3698 +1924 4 24.8428 19.0032 30.2276 -1.20959 -17.1847 2.11456 +1925 4 24.5914 20.4528 30.618 6.24059 -13.3215 -18.0816 +1926 6 50.0702 29.4819 2.87168 7.70946 6.50978 -10.1722 +1927 4 50.8345 29.4231 3.46787 -5.92296 0.441099 -8.02421 +1928 4 50.4135 29.3271 1.96617 -11.3825 0.248157 19.2026 +1929 6 26.3309 13.2577 37.9673 -13.8105 -3.9786 -34.6653 +1930 4 27.2227 13.0528 37.6163 -4.21147 3.58808 27.148 +1931 4 26.2568 13.475 38.8976 18.37 3.27206 13.6317 +1932 6 24.3356 13.8068 16.1475 3.59325 -0.347239 -0.208698 +1933 4 24.7367 14.1162 16.9522 4.68271 -6.41054 14.6744 +1934 4 24.1923 14.631 15.6832 -6.43367 3.48529 -13.6665 +1935 6 21.9593 25.0956 8.01078 27.9223 3.76027 7.52529 +1936 4 22.6404 25.6041 7.51239 -14.7718 -5.75747 5.32796 +1937 4 22.4795 24.6555 8.71494 -11.0917 7.59151 -10.9937 +1938 6 50.1732 25.2931 29.034 -22.8769 -27.0861 -14.4889 +1939 4 50.9231 25.1249 28.4453 9.52927 7.92169 5.9345 +1940 4 50.3853 25.9631 29.6741 16.3661 14.9722 8.20298 +1941 6 23.1854 6.82331 7.6223 5.22953 23.7057 -4.54178 +1942 4 23.9785 7.3899 7.84298 -26.8007 -12.7469 -6.01791 +1943 4 22.4118 7.42329 7.468 18.2581 -13.076 4.30509 +1944 6 6.92213 5.8571 20.8332 2.72627 6.95854 -11.5419 +1945 4 7.54915 6.58218 20.6217 -11.8273 -13.0803 1.39721 +1946 4 6.56012 5.53917 19.9848 5.57208 -2.46181 7.62025 +1947 6 25.395 39.7583 23.949 6.36773 8.3837 -46.9746 +1948 4 25.6324 38.8356 24.0083 0.522678 -6.92882 12.1803 +1949 4 25.626 39.9451 22.9935 -8.38215 2.07882 31.2615 +1950 6 10.8464 30.695 2.12273 2.92699 -11.4721 29.0623 +1951 4 9.93667 30.8598 2.41274 2.41412 3.42254 -4.79395 +1952 4 11.0072 31.0743 1.26994 -5.60296 10.8359 -22.248 +1953 6 23.0784 40.5299 40.0517 -12.8303 7.3127 -19.6888 +1954 4 23.7801 40.7079 39.3995 -2.98216 -3.06267 5.67195 +1955 4 22.2752 40.9489 39.6621 13.0026 -6.04267 8.58422 +1956 6 29.2116 28.3822 37.564 -38.7174 33.0362 -17.1388 +1957 4 28.2182 28.3913 37.3962 39.4392 -4.09178 7.25715 +1958 4 29.4217 27.5495 37.9564 8.20519 -19.4736 9.10227 +1959 6 1.867 12.1738 18.0852 -6.50713 5.08339 -35.4355 +1960 4 2.57398 11.838 18.6163 6.10024 -5.16113 22.8519 +1961 4 1.13063 12.5086 18.5994 -2.48645 -2.83143 13.3981 +1962 6 35.8305 14.0949 8.56039 26.0881 18.3061 13.156 +1963 4 35.1714 13.4739 8.88749 -16.8661 -4.96187 -13.4504 +1964 4 35.7684 14.4109 7.636 -16.9096 -16.2229 2.78164 +1965 6 9.49198 39.8165 37.5846 25.5398 -19.6342 8.10058 +1966 4 10.4488 39.5668 37.3792 -35.3087 19.1509 -1.98674 +1967 4 9.11285 40.4907 37.0027 15.1686 -3.88151 -5.41116 +1968 6 3.54864 30.3444 19.2746 19.2588 -4.84534 25.5649 +1969 4 4.39288 30.8221 19.2218 -5.35887 2.33403 -8.35831 +1970 4 3.69938 29.8 20.0823 -8.98886 6.07327 -15.723 +1971 6 36.3172 32.3761 17.5568 -52.716 -14.5505 -10.7859 +1972 4 37.1181 32.7413 17.8285 45.3049 23.5946 19.1732 +1973 4 36.5447 31.7674 16.8589 0.0557097 -8.91784 -8.34906 +1974 6 22.0674 24.5243 41.4066 13.5104 10.4808 14.5301 +1975 4 21.9193 25.2614 0.114872 1.55544 -1.48024 -5.36737 +1976 4 21.3782 24.5469 40.7428 -11.5581 2.78113 -8.36201 +1977 6 45.7659 15.6016 11.6394 9.02046 4.78635 -7.96304 +1978 4 46.6299 16.0103 11.8091 -2.50167 -1.58301 0.968075 +1979 4 45.9087 14.6499 11.5698 3.7439 -8.72722 -0.994242 +1980 6 22.3679 20.3809 16.0361 -10.6504 -17.4294 -19.3744 +1981 4 21.763 20.3139 16.7773 -4.42579 5.53693 13.3566 +1982 4 23.0073 21.0579 16.2253 11.6801 17.1208 13.2616 +1983 6 25.8325 25.7487 18.9031 6.26908 13.5994 -10.9759 +1984 4 25.2398 26.4837 18.648 3.49723 -12.6326 6.8661 +1985 4 25.3435 25.2434 19.5576 -3.6765 -3.23145 -0.768961 +1986 6 35.3178 34.202 33.2905 -17.6504 -29.1706 1.13026 +1987 4 35.3983 35.1402 33.2641 1.24044 29.706 -1.15043 +1988 4 34.4344 34.0427 33.6774 7.05439 -0.467604 -1.03347 +1989 6 39.2901 17.1075 17.3833 -11.3112 -26.2042 -1.68945 +1990 4 39.9794 17.7123 17.5836 17.425 19.0869 4.79839 +1991 4 38.575 17.6263 16.9966 -1.50153 2.1098 -0.940241 +1992 6 0.398412 14.9432 21.7856 9.03058 1.70326 -1.90296 +1993 4 54.4474 14.9193 21.5731 -3.898 -0.019948 -1.7993 +1994 4 0.528431 14.174 22.3634 -0.170355 0.861544 -0.399335 +1995 6 15.987 23.2263 17.7743 4.36624 14.6934 -7.14303 +1996 4 15.4857 22.9799 16.9684 3.82047 1.22984 7.38673 +1997 4 16.1722 24.1939 17.7179 -4.44652 -15.4901 1.96988 +1998 6 5.24865 11.1141 17.5618 6.95422 37.8037 -9.42255 +1999 4 4.73778 10.3127 17.5906 4.69561 -15.2682 10.3552 +2000 4 6.07662 11.1201 18.0866 -14.6292 -19.4463 0.240297 +2001 6 9.34435 36.7122 13.2675 14.3848 -20.4853 -8.45434 +2002 4 9.62142 35.7704 13.1913 -3.31983 12.7393 -0.467066 +2003 4 9.65952 37.1602 12.4706 -4.49166 -2.86228 3.29419 +2004 6 25.4918 33.5767 0.585194 -13.2513 47.819 -13.0434 +2005 4 25.5067 34.5261 0.924259 2.87868 -31.0124 -5.96193 +2006 4 25.9276 33.0244 1.21144 10.5779 -12.847 23.4116 +2007 6 17.3034 24.3894 31.3332 -3.83374 11.0726 -5.16798 +2008 4 17.6693 25.1812 30.9068 -1.9735 -3.85303 -0.254684 +2009 4 16.6127 24.6926 31.9382 -2.66612 -1.73239 2.61398 +2010 6 50.552 32.7161 27.7939 3.69414 -2.86079 -12.6149 +2011 4 50.6897 33.0491 28.6758 -0.144502 8.45372 13.0825 +2012 4 49.6264 32.8868 27.6344 -12.0524 -1.73095 -4.05681 +2013 6 2.253 37.2274 16.11 8.45807 0.136394 4.49883 +2014 4 3.21927 37.2459 16.107 -3.10104 -5.97474 -11.5471 +2015 4 2.06307 37.5747 16.9848 -8.61924 1.9026 3.91491 +2016 6 25.7683 33.176 8.40354 -18.9203 -11.3347 4.07551 +2017 4 24.8717 33.1921 8.8134 13.9609 -2.48357 -8.81655 +2018 4 25.7602 32.4226 7.7918 -3.67744 3.53954 1.65329 +2019 6 24.768 7.83219 25.4219 17.632 21.1734 16.2998 +2020 4 25.4945 8.36147 25.0103 -20.1597 -14.0103 5.71998 +2021 4 24.2535 7.44908 24.728 -12.2137 -5.73332 -20.4071 +2022 6 44.006 27.3325 21.546 30.1554 -7.9652 -11.3918 +2023 4 43.2457 27.8583 21.7575 -19.7371 1.57643 -2.46296 +2024 4 43.7964 26.4976 21.0884 -11.5694 12.3441 5.98804 +2025 6 20.8391 32.0716 6.72617 12.9902 -8.35788 -26.5741 +2026 4 21.6065 31.456 6.61879 -16.2643 13.1482 10.0653 +2027 4 20.6646 32.3142 7.64123 9.40483 -3.67012 8.54308 +2028 6 0.615177 26.1024 3.99379 -2.52029 5.686 8.70358 +2029 4 0.872898 25.4419 3.3518 0.34785 -8.86692 -8.8337 +2030 4 1.24928 25.9906 4.70547 -1.00806 2.16518 1.82635 +2031 6 23.6932 0.22266 22.8575 19.6208 -9.09848 8.51526 +2032 4 23.2991 1.09802 22.9795 5.26519 -2.66393 -0.960482 +2033 4 24.6108 0.216177 23.2468 -26.6208 7.90328 -9.41734 +2034 6 35.6316 26.9489 6.47476 -11.9227 4.67096 -7.07616 +2035 4 36.2784 26.7656 7.18499 -0.847143 10.2035 -9.59556 +2036 4 35.6247 27.8854 6.12936 11.6979 -23.4314 22.5499 +2037 6 50.1669 7.09081 18.6924 -7.14542 -1.6973 -3.47771 +2038 4 50.8011 7.27946 17.9805 -1.08143 -0.293524 0.841141 +2039 4 49.7425 7.94753 18.8476 4.63932 0.367722 -3.05405 +2040 6 12.4741 14.8288 12.1922 -8.10271 -9.61402 10.4649 +2041 4 11.6958 14.4794 12.6802 13.1948 7.08912 -7.97814 +2042 4 12.1183 15.3251 11.4609 -4.91784 2.70917 -6.99785 +2043 6 52.4614 22.3688 36.3388 -11.0199 -17.3524 -23.0567 +2044 4 51.6251 21.9183 36.1306 -2.17212 11.6706 13.3338 +2045 4 52.9952 21.963 35.6316 8.38603 12.1418 11.4133 +2046 6 41.778 11.4842 39.1192 -2.94788 -8.5466 -71.3066 +2047 4 42.0712 11.6935 39.9642 18.9262 14.1801 48.2999 +2048 4 42.4688 11.7778 38.472 -13.5225 -5.5757 18.7019 +2049 6 13.7869 22.5139 39.1025 -32.0544 -7.10206 -10.9841 +2050 4 12.8164 22.2898 39.2995 40.1723 6.0649 -15.4789 +2051 4 14.0276 22.2847 38.1645 -11.932 2.241 24.8997 +2052 6 28.7471 19.519 21.8427 26.201 -31.4587 -3.42241 +2053 4 29.5077 18.8642 21.7553 -27.3151 19.4313 7.21597 +2054 4 28.709 19.939 20.977 -1.33904 3.86677 -3.41873 +2055 6 8.35104 21.6464 36.3873 -9.70021 11.1463 1.78198 +2056 4 8.59231 22.5715 36.3877 5.92817 6.74417 -5.91108 +2057 4 7.6521 21.6323 37.0621 1.10663 -7.27579 -5.05072 +2058 6 39.9466 23.9759 15.2079 21.5993 -7.98015 -41.1742 +2059 4 40.8727 23.6245 15.2724 -23.8836 11.1149 -0.884493 +2060 4 39.7538 23.9548 14.2182 -0.675121 3.14563 34.0025 +2061 6 8.14826 38.6974 22.5407 10.5164 -8.10765 28.5856 +2062 4 7.68497 39.3831 22.0542 -4.5186 11.15 0.90042 +2063 4 8.43687 39.0737 23.4204 -11.1896 -2.29822 -22.518 +2064 6 10.8609 20.1732 28.9608 12.8413 -0.923384 7.34695 +2065 4 10.0131 19.7426 29.0637 -5.9523 -4.47565 4.1188 +2066 4 10.8844 20.5008 28.0696 -0.703946 5.19258 -12.1525 +2067 6 36.9008 23.822 41.8156 -12.4363 21.7846 -10.0393 +2068 4 37.5711 23.2333 0.167128 40.9996 -19.7248 12.2972 +2069 4 36.1173 23.3131 41.9445 -23.6506 -5.40851 2.0223 +2070 6 23.7894 40.6868 33.3454 12.8596 -15.6087 -7.6142 +2071 4 23.0064 40.9655 33.8068 -12.9523 11.6172 4.83708 +2072 4 23.8763 39.7481 33.6232 3.5481 12.5289 -6.50269 +2073 6 4.67002 19.3025 35.4081 28.9654 -8.37802 15.8464 +2074 4 5.50304 19.0977 35.9037 -20.926 10.8248 -6.78781 +2075 4 4.54874 18.5079 34.879 -7.50763 -2.93955 -6.02594 +2076 6 9.44906 25.7726 10.897 4.32597 -4.58851 8.60165 +2077 4 9.18995 24.8319 10.8983 -5.5655 4.98255 -0.925486 +2078 4 8.69969 26.3126 10.6078 0.159443 -6.7376 0.514864 +2079 6 27.2776 22.4912 13.6121 -0.517147 -7.99313 -8.85992 +2080 4 27.155 21.7331 14.2088 0.0551372 2.14825 -2.63665 +2081 4 27.5226 22.1158 12.7439 -1.12325 6.52643 14.1544 +2082 6 41.0473 18.7721 23.2805 -1.65607 -7.19044 -7.91226 +2083 4 40.4257 18.2083 22.8124 7.09703 -3.21037 0.549063 +2084 4 40.4899 19.4448 23.6465 -2.2525 13.4867 10.2584 +2085 6 46.4847 28.3568 20.1596 21.4343 7.62243 20.4812 +2086 4 45.6558 28.0725 20.6313 23.6124 6.3397 2.68094 +2087 4 47.3103 28.4552 20.7557 -43.4876 -6.08109 -17.1535 +2088 6 14.856 15.3945 30.0569 12.1054 -1.48105 24.8406 +2089 4 14.6669 15.4041 29.1302 -8.67008 -4.83168 -20.7775 +2090 4 14.3859 14.629 30.4429 4.17574 5.50589 -6.96103 +2091 6 23.5299 24.7674 35.2089 8.01546 19.7663 24.3744 +2092 4 22.8065 25.3632 35.4756 2.8295 -9.26237 -7.23473 +2093 4 24.1647 24.8645 35.9517 -5.58112 -4.18239 -8.07128 +2094 6 19.8979 24.2128 28.4372 -8.55524 33.371 -10.5251 +2095 4 20.118 25.106 28.0235 -7.554 -30.7898 14.4583 +2096 4 18.9386 24.2465 28.5992 8.91169 -0.342387 -2.75065 +2097 6 45.9653 7.62821 20.2375 0.645938 -6.46631 40.9505 +2098 4 46.1455 7.81465 21.2011 -4.75538 -9.14986 -26.6761 +2099 4 46.2053 8.42523 19.7798 3.02803 13.7202 -10.1214 +2100 6 38.0274 12.476 8.2804 -12.7973 12.3245 -4.6187 +2101 4 37.3544 13.1993 8.5286 18.4233 -41.2645 -20.6098 +2102 4 37.689 11.8001 7.60922 -1.16355 31.2483 23.3325 +2103 6 46.9232 18.1908 8.45127 -20.6048 6.85227 14.7641 +2104 4 46.2435 17.4987 8.55233 4.56757 4.50302 -0.225601 +2105 4 47.4224 17.9381 7.68168 11.4282 -5.99968 -17.9171 +2106 6 10.854 13.9656 9.37577 10.6617 18.3473 -18.9154 +2107 4 10.3554 14.661 8.90618 -4.87744 -10.6328 11.7585 +2108 4 11.7492 14.0754 8.99486 -7.79483 -7.36366 10.4335 +2109 6 34.413 5.42618 14.0852 -12.6861 0.159125 26.6885 +2110 4 35.1199 5.9296 13.6715 10.4361 -4.78744 -13.6438 +2111 4 34.2786 4.53955 13.7091 11.464 2.02167 -7.62295 +2112 6 0.18261 0.234369 22.9555 2.77695 -16.1069 -0.480131 +2113 4 0.268342 41.6651 22.1144 -0.0234796 4.94264 7.55149 +2114 4 54.831 1.09037 22.7433 -8.12427 18.964 -5.90735 +2115 6 40.9343 30.5497 37.8912 -0.822728 -5.40818 -2.29365 +2116 4 40.0406 30.8803 38.1728 23.6728 -16.1598 5.2797 +2117 4 41.3254 29.8415 38.4693 -14.8835 20.0143 -6.13723 +2118 6 16.6534 17.3205 12.6874 14.7099 15.3782 -9.06546 +2119 4 16.1954 16.505 12.4572 -1.18797 -4.10455 -0.493236 +2120 4 17.006 17.6533 11.8352 -5.05849 -6.69802 12.8635 +2121 6 29.6898 5.4323 24.749 -0.0153423 -4.79708 -9.00604 +2122 4 30.3311 5.93507 24.2276 2.5605 1.293 3.45927 +2123 4 29.9547 5.54756 25.6733 0.859724 2.70473 -2.20341 +2124 6 49.8976 0.279 27.2063 11.3554 -10.6099 9.68168 +2125 4 49.8114 0.578981 26.2935 2.75523 0.634109 -3.06626 +2126 4 50.8097 41.8349 27.2847 -10.6363 5.42595 -5.44518 +2127 6 31.2372 31.739 15.2138 3.99594 22.7956 -4.27207 +2128 4 31.6256 30.8953 15.4507 4.79789 -4.71254 6.82751 +2129 4 31.9624 32.4004 15.1381 -14.4355 -14.737 3.33184 +2130 6 35.7805 24.1465 16.9504 11.9916 -3.59376 -8.04525 +2131 4 35.6914 24.9231 16.3572 2.28972 -11.6943 5.94213 +2132 4 36.6882 23.763 16.8157 -19.8391 7.30154 4.46135 +2133 6 24.2601 4.62781 36.7306 -2.73038 -12.1142 -21.0154 +2134 4 24.8177 5.17448 37.2794 5.25293 5.76293 7.44764 +2135 4 24.6802 4.67277 35.8537 -9.35577 -2.69704 9.81341 +2136 6 17.5719 12.8989 3.66466 27.7221 -13.8379 -12.2911 +2137 4 17.7111 13.5231 2.92461 -8.26776 -5.83385 13.2655 +2138 4 16.7968 13.1561 4.15408 -15.8703 8.33112 4.7305 +2139 6 4.16771 14.2922 18.2601 -1.91899 -29.1082 -10.1028 +2140 4 4.22837 13.3107 18.2109 4.90834 19.7408 -0.578384 +2141 4 3.27435 14.4381 18.5824 -9.9871 6.86755 4.44487 +2142 6 19.1699 36.8381 22.3902 -4.55286 10.0742 -5.97046 +2143 4 18.832 36.3461 23.1414 -4.92402 -9.67799 11.164 +2144 4 19.5712 36.1952 21.8056 6.33502 -12.5333 -3.55186 +2145 6 15.653 11.96 13.2084 19.351 18.6963 0.185202 +2146 4 15.6609 12.833 12.7547 -2.35489 -19.4305 9.56752 +2147 4 16.5767 11.8359 13.5469 -18.24 -1.16426 -6.81767 +2148 6 24.7461 21.9204 5.38797 -27.1503 3.38708 1.08719 +2149 4 25.0422 21.7466 6.29562 -9.42613 0.489783 0.293639 +2150 4 23.7615 21.7936 5.33342 31.5349 -1.60743 10.1723 +2151 6 52.731 18.5617 35.2291 -23.3227 -9.96089 -3.35821 +2152 4 52.3432 18.0885 34.4925 12.0283 -8.22578 -16.7439 +2153 4 51.9379 18.6142 35.7503 -4.18579 12.1235 24.3517 +2154 6 3.56339 27.2782 25.2861 -13.9068 -17.971 -11.9546 +2155 4 3.93933 27.1708 26.1554 6.48024 -2.07304 15.4908 +2156 4 3.97283 28.0403 24.8958 8.97188 17.1762 -5.24442 +2157 6 34.4703 32.9949 30.674 6.71734 26.132 41.1649 +2158 4 33.5303 32.9277 30.8218 -10.267 -13.4259 -20.1884 +2159 4 34.6757 33.5653 31.4552 13.6938 -14.1125 -21.2315 +2160 6 35.2703 23.7477 9.841 1.59588 4.98779 0.126485 +2161 4 34.557 23.9691 9.22977 0.987563 3.83206 0.754652 +2162 4 35.6213 22.923 9.5082 6.82753 -10.3388 -1.5208 +2163 6 42.4139 15.7114 8.97964 24.1102 0.334397 4.42901 +2164 4 41.6569 15.4185 8.4899 -23.1764 -3.9339 -8.15459 +2165 4 42.1019 15.9745 9.85446 -9.30455 -0.897043 1.06511 +2166 6 7.76859 28.8573 32.9442 -15.9037 16.0354 -10.4898 +2167 4 7.97908 28.1549 33.5519 6.36032 -10.9608 11.0673 +2168 4 8.54203 29.0732 32.4131 7.8922 -1.0693 -1.41065 +2169 6 17.6887 41.2397 36.4833 -13.2152 -10.2381 33.1554 +2170 4 16.9194 41.8027 36.6113 -2.7651 1.17246 3.809 +2171 4 17.9462 41.408 35.602 16.1966 5.46369 -29.7656 +2172 6 28.4973 24.2486 15.5471 -12.6583 -10.112 -30.4241 +2173 4 29.1017 24.9078 15.1992 6.65529 6.29726 4.69488 +2174 4 28.2904 23.7156 14.7389 1.39534 3.17619 21.4563 +2175 6 20.9519 16.2974 1.15248 44.1264 9.982 -6.69009 +2176 4 20.9895 15.4004 1.43432 -0.0798072 -22.9414 11.198 +2177 4 20.0538 16.5254 1.09156 -44.6028 7.62895 -2.50253 +2178 6 31.1717 40.7384 5.29995 -1.14335 -24.9234 -14.6262 +2179 4 30.3101 40.4535 4.98914 0.542473 -7.39845 -0.335603 +2180 4 31.0069 41.6267 5.54556 -2.10438 36.1837 12.2935 +2181 6 29.9172 24.7601 36.4536 2.52587 12.7881 -5.39704 +2182 4 30.4095 25.4459 35.9567 -7.35112 -4.48214 8.13095 +2183 4 30.0744 23.9625 35.9621 2.47343 -16.947 -5.4104 +2184 6 8.66853 31.0461 3.90506 3.77884 -22.5587 -9.29968 +2185 4 7.73756 30.8263 3.92016 -7.28297 1.54323 -1.95967 +2186 4 8.75192 31.9258 4.24445 1.80419 26.3875 10.0131 +2187 6 5.53845 32.6958 11.4143 8.71933 -16.8124 -2.49586 +2188 4 4.77303 33.2403 11.6664 3.11219 -11.1916 -2.75881 +2189 4 5.22904 31.759 11.32 0.456358 25.4252 4.80969 +2190 6 45.6505 35.4572 20.4414 3.44959 -7.44503 -2.03407 +2191 4 45.0984 35.4295 19.6379 6.4013 -0.712815 7.57821 +2192 4 46.1919 34.6303 20.4513 -12.6908 13.7486 -3.45541 +2193 6 19.5117 2.78375 9.7759 -32.3978 -9.59039 -17.0694 +2194 4 19.2358 3.70482 9.71872 -0.134373 3.8207 4.89971 +2195 4 18.7417 2.29322 9.36028 25.7327 11.9734 13.3495 +2196 6 54.9587 9.07031 10.9149 6.82732 -5.63024 12.2566 +2197 4 54.8294 8.9199 11.8667 -4.4018 -2.06217 -5.32285 +2198 4 0.663346 9.73371 10.8556 1.49355 -0.124783 -2.42855 +2199 6 21.0387 26.5729 14.7801 20.1883 -1.49652 -44.4677 +2200 4 21.3075 26.2685 13.8316 -13.9911 15.8829 47.28 +2201 4 20.1009 26.3915 14.9175 1.72514 -4.1332 -5.78598 +2202 6 14.1556 30.5195 27.5512 33.9559 3.86758 5.7066 +2203 4 14.6157 30.1887 28.3748 -9.20473 8.28645 -28.3289 +2204 4 14.8625 30.9321 26.9648 -24.7422 -11.1229 20.6028 +2205 6 29.8153 17.3336 31.0863 -17.242 12.2647 2.89366 +2206 4 30.6608 17.508 30.6961 22.1461 -2.37775 -6.86255 +2207 4 29.3509 18.1813 30.9961 -0.156979 -6.11616 8.89085 +2208 6 50.8803 17.2897 27.8178 -36.3925 19.5692 4.68662 +2209 4 49.966 17.6961 27.8739 30.6942 -17.822 -8.40051 +2210 4 51.3989 17.8346 28.4178 4.99425 -5.86793 -0.268148 +2211 6 46.2649 37.0836 13.9834 -5.2064 -3.89214 -29.9265 +2212 4 46.1297 37.5324 14.8008 -1.4234 12.1478 29.9589 +2213 4 45.6025 37.4999 13.3985 5.55615 -7.46483 0.310394 +2214 6 38.1938 37.2652 33.1426 -7.30823 -21.5307 12.8964 +2215 4 38.5245 37.3061 34.0621 0.43181 3.22683 -10.2889 +2216 4 38.5338 38.0078 32.6437 8.99657 15.0472 -1.17828 +2217 6 41.835 13.3432 31.1173 -10.6585 13.9874 21.8211 +2218 4 41.5818 13.8647 31.919 4.55225 -14.0949 -20.2689 +2219 4 42.3932 12.6177 31.4161 6.34511 -7.13184 -1.29627 +2220 6 46.8964 12.6581 17.833 -7.85032 10.4907 -16.4819 +2221 4 46.6484 13.6178 17.7542 4.08188 -24.8978 -7.40371 +2222 4 46.6377 12.1709 16.9987 5.46876 16.7046 19.0746 +2223 6 32.0579 10.0934 10.6503 -8.64381 28.9058 -4.43215 +2224 4 31.7849 9.65569 11.4853 0.173068 15.3159 -11.0765 +2225 4 31.7767 11.0763 10.6467 12.4785 -48.8318 10.7993 +2226 6 34.0094 11.373 6.75969 12.8388 24.8548 11.4886 +2227 4 33.4875 10.5861 6.69386 -15.1181 -21.0438 1.83339 +2228 4 33.7853 11.7772 7.62543 1.85262 -6.17932 -11.7084 +2229 6 45.3294 30.8612 19.494 8.3992 -12.4908 2.66791 +2230 4 45.3133 30.6326 20.4263 -2.2594 2.91399 10.7741 +2231 4 45.8271 30.1094 19.1443 -2.81922 5.63857 -5.34771 +2232 6 20.3557 0.57205 7.14927 -0.865045 4.87397 8.36509 +2233 4 20.1887 0.590785 8.10086 -2.30268 5.48708 -2.96522 +2234 4 20.2885 41.5556 6.94299 -1.24307 -13.5357 -7.1472 +2235 6 15.9783 39.4524 4.13892 -0.0151964 -9.48015 -5.29824 +2236 4 15.6158 39.9898 3.41173 1.6648 1.85694 12.5404 +2237 4 15.64 39.7774 4.99485 -4.20756 5.15612 -10.0141 +2238 6 52.4256 16.4667 25.1127 -17.0507 13.8269 -2.02364 +2239 4 51.8848 16.9346 25.7614 0.982734 -7.60925 5.82434 +2240 4 52.3383 17.0704 24.353 8.48557 -12.5426 -0.219872 +2241 6 38.5361 13.0039 3.23845 15.1533 54.069 38.768 +2242 4 38.651 13.64 4.04305 -2.16968 -28.4467 -44.0011 +2243 4 38.0019 12.309 3.58724 -16.6469 -22.8542 0.297491 +2244 6 35.13 29.6899 31.1766 -32.8294 1.63854 50.8714 +2245 4 35.4825 30.1651 30.4465 16.0479 15.276 -26.3528 +2246 4 34.6741 30.3613 31.7643 12.1102 -21.125 -19.7306 +2247 6 9.51973 33.7498 4.86217 -21.8826 5.77433 4.68556 +2248 4 9.27059 34.3826 5.57285 8.50621 -13.5655 -12.6408 +2249 4 10.3866 33.3952 5.041 8.90701 -1.44023 3.12186 +2250 6 21.534 22.0642 20.5279 -11.3341 -5.53839 17.2976 +2251 4 20.8989 22.7675 20.339 3.51908 1.76985 -0.685914 +2252 4 21.3133 21.7346 21.437 6.74336 6.48682 -22.5749 +2253 6 37.579 11.1901 41.2936 -40.5688 -13.8213 19.6839 +2254 4 37.9154 11.8125 40.6731 20.8822 18.4609 -22.3708 +2255 4 38.2848 10.6639 41.6667 19.2795 -3.39896 1.21846 +2256 6 33.8862 1.42431 38.7362 -9.76991 -12.243 -0.11253 +2257 4 33.6023 0.553369 38.4181 2.20193 5.31751 1.25532 +2258 4 33.9041 1.3558 39.7008 -0.574955 5.51976 -3.65617 +2259 6 4.57166 26.6812 27.9899 28.8485 -45.5436 -4.48952 +2260 4 5.15229 25.8908 28.1565 -23.3183 20.9594 -13.553 +2261 4 4.90489 27.293 28.6243 -0.866291 24.6335 11.5543 +2262 6 10.2514 0.902381 11.6154 -4.58149 -17.6537 26.8062 +2263 4 10.6592 1.12475 12.4668 -4.26503 -7.612 -8.38981 +2264 4 10.5004 1.60734 11.0484 5.83944 23.9466 -26.0443 +2265 6 17.6545 19.8255 2.35686 18.7122 -0.118329 6.29025 +2266 4 17.9031 20.43 1.64019 0.754008 -4.0492 2.7955 +2267 4 18.4832 19.3436 2.60738 -15.0404 10.1651 -4.64219 +2268 6 32.418 25.6758 16.4635 3.6076 24.4214 11.9097 +2269 4 33.0171 26.0095 17.1449 -9.06157 4.09224 -4.99535 +2270 4 32.7904 24.838 16.2462 -1.14602 -28.0291 -11.1265 +2271 6 33.2468 10.6359 0.32388 9.93322 -26.76 -6.12289 +2272 4 32.8861 10.0042 41.5485 10.341 19.2926 16.9559 +2273 4 34.0854 10.2367 0.697563 -23.7256 11.8288 -10.1734 +2274 6 4.94758 4.52061 10.1416 10.7499 4.98188 17.9077 +2275 4 4.04768 4.863 10.1726 -0.273394 -4.88493 2.42241 +2276 4 5.29522 4.53942 11.0694 -10.4701 1.63881 -23.2648 +2277 6 27.0943 16.9779 9.5563 -20.4641 3.47693 -11.2288 +2278 4 27.2045 17.5151 10.3493 -1.38601 2.5137 2.70549 +2279 4 26.2214 17.2494 9.17658 21.4447 -4.2653 12.7286 +2280 6 9.99194 10.5198 19.3763 9.42123 -1.05348 44.8422 +2281 4 10.4342 9.89794 18.8118 9.85784 -12.5922 -17.5865 +2282 4 10.1605 10.162 20.3013 -9.67835 15.4527 -31.558 +2283 6 19.5738 8.53792 27.8563 25.8928 -1.13542 15.4327 +2284 4 20.113 8.77024 28.6584 -12.6361 -5.62488 -23.922 +2285 4 20.1113 7.87775 27.3567 -13.5748 14.3815 9.08869 +2286 6 47.0629 38.9588 23.1271 -13.9792 1.44752 0.432651 +2287 4 47.6691 38.8737 22.3925 4.22694 -4.47738 -4.61135 +2288 4 46.1776 38.8683 22.7344 3.33277 3.24373 3.79368 +2289 6 19.6833 25.3678 11.2608 -44.4501 -0.725843 0.650565 +2290 4 19.0139 24.6272 11.3182 24.6346 19.551 -2.60477 +2291 4 19.1544 26.1629 11.5326 10.4738 -19.1562 -5.87093 +2292 6 27.3884 13.4531 15.7313 17.4935 -10.3398 7.87305 +2293 4 26.7289 13.8255 16.2909 -22.225 11.7393 10.4827 +2294 4 28.1076 13.2654 16.3619 5.43008 -3.78237 -14.8549 +2295 6 18.6476 14.1287 1.42435 5.12245 -4.46092 -43.403 +2296 4 18.3969 15.043 1.25229 -6.07889 7.26273 6.76186 +2297 4 19.169 13.9274 0.593091 -12.995 -1.5013 29.2583 +2298 6 42.2956 22.0175 32.4812 -31.5033 5.69606 -11.9689 +2299 4 42.0953 21.6028 33.3343 -5.26012 -0.0861087 1.91793 +2300 4 41.4492 22.4721 32.2087 27.3869 -15.7461 8.96812 +2301 6 10.0338 9.4525 2.5044 21.0744 -25.1182 9.26795 +2302 4 9.23419 9.82009 2.8603 -22.4046 15.9317 4.21557 +2303 4 10.2146 8.68383 3.09556 -0.513225 11.8796 -14.6695 +2304 6 6.81454 1.43994 21.9965 -17.8896 2.42247 -7.4431 +2305 4 5.91626 1.63042 21.618 24.8197 -16.2049 7.25345 +2306 4 7.09146 0.513113 21.8391 -15.5061 11.1514 -4.64506 +2307 6 11.279 27.0428 18.9739 -2.94846 37.5248 -0.887691 +2308 4 11.8405 27.0241 19.773 -2.49358 0.901506 -7.48985 +2309 4 11.2189 28.0198 18.7087 3.35633 -32.7966 13.2637 +2310 6 41.4624 20.5117 27.2131 -8.71247 23.609 -19.3396 +2311 4 41.6397 21.203 27.8749 -2.09795 -12.5822 -0.139714 +2312 4 41.4581 19.6661 27.6488 3.25287 -9.08293 14.2442 +2313 6 15.4472 24.107 33.4286 7.47915 5.78269 -2.8589 +2314 4 14.6947 24.3175 34.0087 6.10264 -6.26217 -2.67023 +2315 4 15.704 23.1687 33.5026 -8.54671 4.87938 10.939 +2316 6 36.1332 16.3778 10.0175 -2.81296 8.13669 8.31829 +2317 4 36.0433 15.4982 9.63146 0.0153009 -3.05325 1.23302 +2318 4 36.1908 16.2895 10.9807 1.05799 -3.5475 -8.17119 +2319 6 51.7056 16.2618 2.12066 8.195 -18.8618 -27.7488 +2320 4 51.3212 16.7491 2.82948 -13.5116 6.32013 30.1636 +2321 4 51.8333 15.3227 2.36395 -2.62212 15.8907 6.5854 +2322 6 23.4154 8.54771 39.774 19.4785 -4.07885 -14.0827 +2323 4 23.6619 8.92799 38.8876 -4.40964 -10.2511 30.1282 +2324 4 24.1933 8.06554 40.1323 -10.8686 15.1901 -10.9325 +2325 6 36.7652 34.4407 21.0996 -10.7203 -4.0633 -8.35763 +2326 4 37.1575 34.5988 20.2292 -2.24352 0.118594 1.89686 +2327 4 35.7922 34.4168 20.9564 13.0606 -0.027129 3.88767 +2328 6 14.1394 8.88964 27.2822 8.4001 33.0473 -16.3093 +2329 4 13.5583 8.17177 27.4325 -25.1847 -27.8879 6.89622 +2330 4 14.9981 8.62308 27.6007 12.278 -0.771553 4.38 +2331 6 20.6523 37.4857 25.1916 -4.76336 -9.80096 2.89409 +2332 4 20.8435 36.6327 24.7231 -2.60537 24.8018 1.29013 +2333 4 20.5883 38.2205 24.557 2.95927 -14.0914 0.587832 +2334 6 28.8259 24.466 30.0361 -12.0182 1.20484 18.6414 +2335 4 28.1863 24.5363 29.306 15.5663 0.0495978 -2.57679 +2336 4 29.6571 24.0617 29.7579 -0.701354 -5.27936 -13.535 +2337 6 8.3767 11.9994 23.6977 15.286 -11.9681 20.7139 +2338 4 9.3753 12.0245 23.8359 -31.6027 -4.22616 -3.50543 +2339 4 7.96209 11.4264 24.4013 16.8905 14.3689 -13.5243 +2340 6 16.0974 26.6628 22.9497 0.767107 4.93659 2.67852 +2341 4 16.422 25.9025 22.452 -4.69466 0.466105 1.02544 +2342 4 15.3072 26.4353 23.4595 5.90508 -1.9072 -2.1838 +2343 6 22.3492 41.3933 9.48833 17.1541 -15.2597 3.14364 +2344 4 22.6076 0.330473 9.13574 5.89797 15.5422 -4.87712 +2345 4 21.4389 41.4869 9.73785 -21.2641 2.73615 1.78898 +2346 6 49.3865 19.1849 32.379 28.5034 -27.5288 -8.8444 +2347 4 49.9591 18.5119 32.8294 -20.0237 22.3317 -7.01358 +2348 4 48.8882 19.6696 33.032 -5.7885 3.32597 15.4548 +2349 6 29.6797 28.4194 31.2347 -18.17 -6.54897 12.3532 +2350 4 30.6054 28.3362 30.9452 0.112823 -13.8933 8.50124 +2351 4 29.3632 27.6339 31.7874 27.6893 19.0339 -22.4607 +2352 6 5.1089 39.1304 23.5821 16.3589 -26.7425 38.52 +2353 4 5.38369 38.72 24.4786 -14.1195 25.2427 -41.8592 +2354 4 5.12138 40.0884 23.679 1.29424 5.88982 9.05127 +2355 6 42.9406 13.5828 41.5963 2.4548 -20.3274 5.45752 +2356 4 42.752 14.3543 41.1051 4.71299 30.6973 -25.311 +2357 4 42.1302 13.4831 0.159852 -12.9765 -12.2431 17.3873 +2358 6 21.226 12.4267 7.36435 31.2446 -3.521 -2.03074 +2359 4 20.2961 12.4647 7.18572 -19.4619 -2.59914 -12.879 +2360 4 21.5838 11.6146 6.96487 -5.92297 6.31526 1.33966 +2361 6 43.1402 26.8798 37.6925 36.8226 -18.0871 25.2922 +2362 4 42.3701 26.4861 37.2457 1.92095 -10.9538 3.42147 +2363 4 43.8051 26.2366 38.1772 -44.9135 25.1765 -29.4158 +2364 6 19.5374 10.6589 41.6895 -5.57828 -38.0023 -10.1688 +2365 4 19.1336 10.6448 0.637369 -6.5477 2.89313 17.0607 +2366 4 19.8005 11.5407 41.5226 10.6711 39.664 -4.3781 +2367 6 53.6211 10.0725 3.2523 6.57913 5.47914 -9.18923 +2368 4 54.2317 10.83 3.34927 -4.54537 -9.93589 0.0420736 +2369 4 54.0384 9.44833 2.62164 -2.29754 8.8252 9.03809 +2370 6 17.5636 20.1992 28.4305 -16.5699 17.1528 15.5915 +2371 4 18.0548 19.7019 27.7957 9.40873 -10.9714 -15.8242 +2372 4 18.1497 20.2955 29.1876 1.50874 1.07066 2.83373 +2373 6 36.8673 7.33814 1.69171 -42.7001 9.70605 -8.47937 +2374 4 37.6788 7.60022 2.09727 18.2611 10.2246 9.26811 +2375 4 36.4242 8.16776 1.39628 11.5951 -12.345 5.16871 +2376 6 29.225 41.4226 1.83075 -19.1389 21.107 -1.05665 +2377 4 28.4254 0.0289368 2.09685 16.3458 -11.1471 3.47601 +2378 4 29.1672 41.4088 0.871311 7.531 -2.47214 -5.14574 +2379 6 13.5148 3.09025 8.11784 -10.8355 13.5741 -3.86075 +2380 4 12.8447 3.80664 8.08285 8.27234 -10.6709 -2.48032 +2381 4 13.8247 3.09872 9.02804 1.30446 -5.60755 1.07776 +2382 6 15.035 29.5824 18.5052 -13.3664 3.09019 -9.07378 +2383 4 14.628 28.8743 17.9722 6.78876 3.62049 6.93265 +2384 4 14.2975 30.1967 18.6986 12.8362 -2.82157 -1.1162 +2385 6 10.5118 24.7077 24.3903 18.3301 23.9761 -31.3173 +2386 4 10.707 24.7057 23.4146 -4.2845 7.89501 28.372 +2387 4 10.0612 23.8909 24.4849 -17.9274 -27.8 13.6507 +2388 6 2.3293 13.8562 25.1542 8.14415 -2.44132 2.05706 +2389 4 1.63302 13.4321 24.6436 -3.32338 -7.08116 -5.4939 +2390 4 2.0923 14.7815 25.112 -7.52471 9.11743 -0.122921 +2391 6 31.8571 32.759 29.7983 3.65167 10.3578 -8.56752 +2392 4 30.9277 32.9381 29.9784 -0.622435 -3.80813 0.732423 +2393 4 31.8884 31.8723 29.4276 -3.71181 -5.10697 -2.58235 +2394 6 37.531 40.8209 33.967 -23.153 -16.1875 5.3836 +2395 4 37.3251 40.1347 34.6985 0.870468 26.6491 -35.3147 +2396 4 36.773 40.8784 33.3102 18.3716 -9.25033 25.8989 +2397 6 24.0485 38.1313 34.3431 -11.5105 1.837 -35.773 +2398 4 24.1907 38.198 35.2802 9.24451 -7.73664 19.5979 +2399 4 24.4675 37.3552 33.934 1.62169 3.10325 14.1331 +2400 6 37.1852 22.5711 7.36841 5.54302 -17.8805 15.7599 +2401 4 37.6193 21.7136 7.5635 -9.24307 15.2983 -3.07678 +2402 4 37.2973 22.7156 6.43503 3.10694 -1.55352 -15.3513 +2403 6 4.30637 23.241 35.6005 -21.8515 -3.12039 0.833232 +2404 4 4.28153 22.3978 35.1252 -1.17938 4.50836 1.52069 +2405 4 3.36633 23.5034 35.7569 13.5984 -2.36814 -1.35472 +2406 6 15.7372 14.8984 2.68389 5.83394 8.18523 30.6602 +2407 4 16.0581 15.8209 2.80401 -5.66096 -17.7803 -6.78984 +2408 4 15.4195 14.7671 1.79524 0.865375 8.28049 -11.4308 +2409 6 48.1667 23.1873 2.04358 2.14857 -5.2771 -14.5053 +2410 4 48.6748 23.4267 2.82287 11.4848 0.866046 3.26637 +2411 4 48.7964 22.9219 1.32588 -13.3162 5.875 14.6145 +2412 6 24.1221 19.9752 21.5371 -32.3717 23.6383 6.86593 +2413 4 24.143 19.3917 22.3107 11.6246 -2.80692 -10.3828 +2414 4 24.7866 19.7762 20.8968 22.5091 -14.1667 -7.68302 +2415 6 10.5822 29.3968 5.14403 -6.21678 -11.6361 15.7318 +2416 4 9.83188 29.7897 4.67624 10.1791 9.93667 -6.35089 +2417 4 11.4324 29.7717 4.90568 -2.60747 8.99296 -10.7541 +2418 6 5.96985 27.6957 31.2251 14.0826 -21.4471 -14.909 +2419 4 6.62108 27.1001 30.7651 -15.2176 13.0885 7.83628 +2420 4 6.49554 28.1541 31.8886 3.5811 4.10899 4.91189 +2421 6 18.524 25.7945 15.3346 -6.80319 -1.26411 -41.3947 +2422 4 18.3129 25.8537 16.2191 -1.03447 -6.47723 71.4836 +2423 4 17.8509 26.3975 15.0287 -5.96066 9.61194 -22.438 +2424 6 52.0911 37.2147 11.1191 10.7944 -12.7592 -3.2574 +2425 4 52.6735 36.5031 10.7991 -6.06835 6.24709 5.19982 +2426 4 52.6754 37.9802 11.2539 -6.64808 -1.57102 -0.449092 +2427 6 46.8545 14.6154 7.32174 -10.4102 9.08531 6.17155 +2428 4 46.1761 15.2305 7.76384 29.9054 -34.6086 -7.32766 +2429 4 47.196 13.9114 7.91569 -13.0839 18.0399 0.731203 +2430 6 22.2426 0.701706 41.6733 41.1626 12.534 -29.9538 +2431 4 22.236 1.66756 41.6378 -9.79705 -6.68715 4.90956 +2432 4 23.0808 0.492341 41.1545 -29.2322 -0.545859 23.5967 +2433 6 4.06645 14.7285 9.26505 -5.79968 22.7562 -12.5209 +2434 4 3.53709 15.5501 9.07402 9.13976 -21.8289 3.48331 +2435 4 4.94549 14.9564 8.94351 2.1847 -1.50717 0.750146 +2436 6 37.293 12.6643 37.0348 -15.3153 -6.18171 16.0178 +2437 4 37.7524 12.8164 37.9019 -17.8573 -2.14895 -9.99561 +2438 4 36.3666 12.3049 37.1727 33.7628 8.85249 1.83374 +2439 6 26.6624 29.0693 40.5955 -26.637 27.4899 13.7151 +2440 4 27.0962 28.2693 40.8235 19.1059 -29.7051 -2.9078 +2441 4 26.7436 29.2635 39.6647 9.93266 -1.33043 -11.4317 +2442 6 7.23743 13.8563 3.32048 -33.1041 -30.3754 -14.41 +2443 4 7.96064 14.4301 3.56742 25.5688 -7.52041 0.820923 +2444 4 7.42976 12.8854 3.09984 6.81051 43.2082 15.4509 +2445 6 8.94797 34.8532 28.8254 23.4184 -23.2786 -12.4265 +2446 4 9.89546 35.0323 28.6727 -12.7097 -5.00209 3.03018 +2447 4 8.59604 35.6886 29.0779 -14.3686 23.8739 12.2374 +2448 6 37.2014 40.0808 40.1141 12.7521 0.43192 13.6168 +2449 4 36.2619 40.0837 39.9632 -10.4254 2.72875 -6.67898 +2450 4 37.248 39.4512 40.8496 7.71934 0.19736 -2.65382 +2451 6 30.3728 6.17428 27.2502 2.34222 12.9127 24.6773 +2452 4 30.0491 5.75377 28.1093 17.5599 21.8776 -23.7977 +2453 4 31.0277 6.90628 27.4549 -18.5498 -22.5685 3.02853 +2454 6 10.4851 22.8816 18.2947 -6.39025 -14.7202 -25.3901 +2455 4 11.3539 23.0451 18.66 8.78619 -1.44678 0.615593 +2456 4 10.601 22.3432 17.4702 -0.435219 15.7289 22.4338 +2457 6 35.9047 14.2516 40.1476 -11.9566 8.08227 -8.12446 +2458 4 35.3828 14.5983 39.4171 17.9635 11.5828 -3.36223 +2459 4 35.2535 13.6726 40.504 -8.36759 -16.975 21.7169 +2460 6 6.70775 1.0715 17.7189 7.50642 -21.2746 -7.36561 +2461 4 6.22784 1.34485 18.5084 1.44497 -10.5234 3.95628 +2462 4 6.91772 0.0894674 17.7256 -13.4419 30.1572 13.7277 +2463 6 41.3365 34.0623 33.1636 23.1157 -5.84267 13.8333 +2464 4 40.4227 34.234 32.9444 -15.3258 11.3352 -14.6542 +2465 4 41.9184 34.5849 32.5841 -12.4833 3.91505 -3.84565 +2466 6 37.2858 0.99342 41.2878 7.36827 13.3221 -16.8172 +2467 4 37.4859 0.112276 40.9658 -1.88555 -12.2628 0.361589 +2468 4 37.4834 1.0172 0.312287 5.29267 -3.40266 15.6364 +2469 6 25.2541 30.9749 6.2071 -22.7336 2.5299 17.3506 +2470 4 26.0217 31.2424 5.69829 1.89843 -3.96463 -15.2281 +2471 4 24.4182 30.8551 5.69564 23.045 5.74277 3.20871 +2472 6 14.1871 24.4929 28.313 -6.35756 40.4048 -1.58139 +2473 4 14.3311 23.6816 28.7714 -3.10946 -31.1704 -0.0360927 +2474 4 13.792 24.4319 27.4273 2.40698 -14.1025 6.50138 +2475 6 34.2078 26.2332 36.0169 -41.3887 31.6455 20.302 +2476 4 35.1375 26.2713 36.1926 18.3831 1.21525 6.50399 +2477 4 33.7458 26.9646 36.5669 26.0782 -29.6148 -21.0343 +2478 6 32.3696 8.32545 27.9988 -31.7689 14.924 14.5852 +2479 4 32.5206 9.30939 28.0669 10.5891 -30.1429 -9.37737 +2480 4 33.1235 7.86931 27.6333 20.3768 10.5357 -6.59273 +2481 6 11.7881 0.276326 26.9686 -1.26514 -24.1343 -2.09554 +2482 4 11.7898 41.2288 26.6922 -1.19404 21.3361 9.01519 +2483 4 11.5977 0.31005 27.9205 2.09711 -1.6438 -10.9729 +2484 6 1.68282 0.256654 10.3371 7.78574 -7.1909 -12.7427 +2485 4 1.59984 41.2742 10.69 -0.913761 -2.35777 -0.20094 +2486 4 1.41183 0.821253 11.0453 -5.61238 10.3042 16.839 +2487 6 6.75659 13.8554 8.24275 2.15336 8.75665 -12.4729 +2488 4 6.4538 13.9004 7.29654 11.603 6.79512 25.9161 +2489 4 7.29723 14.6482 8.44053 -3.39366 -6.31817 -8.96948 +2490 6 22.229 20.5516 6.16712 -19.4021 -6.23502 11.2792 +2491 4 21.7175 21.3783 6.29668 6.22315 -10.0472 -0.391558 +2492 4 21.7004 19.8262 6.58709 9.33903 15.1246 -7.94106 +2493 6 17.3809 20.4508 10.8712 -6.33142 3.08518 -4.04876 +2494 4 16.5461 20.08 10.4568 21.8919 23.129 5.85777 +2495 4 17.5363 21.4129 10.6625 -13.97 -26.3983 1.7074 +2496 6 17.7006 4.52466 19.5892 5.66371 -4.97651 -9.86024 +2497 4 16.9376 4.52739 20.1892 -4.06273 -5.34645 -7.80596 +2498 4 17.5412 3.84457 18.8839 -0.885651 16.9891 23.3258 +2499 6 0.475545 18.1168 40.0844 5.30586 -7.45209 -16.0452 +2500 4 0.255658 18.7395 40.7612 -0.602959 14.3131 10.4938 +2501 4 1.33302 18.3868 39.7002 -7.70736 -6.31105 3.74686 +2502 6 22.9439 24.8338 27.8349 -3.23408 23.09 -51.7359 +2503 4 22.7283 25.5292 27.1178 5.97449 -27.0764 31.3639 +2504 4 22.8278 25.2464 28.677 -4.11703 14.8593 21.0934 +2505 6 42.7959 39.1553 26.7627 -13.6288 14.9904 24.3142 +2506 4 42.9559 38.4383 26.1586 10.7263 -7.78522 -15.113 +2507 4 43.351 39.9224 26.5692 3.77188 -7.24305 -5.18193 +2508 6 26.2354 3.05796 21.7982 1.74018 25.1467 -10.7915 +2509 4 25.6923 3.78105 22.1642 10.9011 -13.8467 -3.1836 +2510 4 26.7888 3.50003 21.1142 -10.0122 -11.5362 10.4851 +2511 6 54.6007 9.88011 29.5829 2.61324 -0.835643 16.9334 +2512 4 53.983 9.1383 29.6239 1.49377 0.577448 -2.59463 +2513 4 54.746 10.0983 30.5296 -2.21833 -1.79811 -18.9561 +2514 6 24.7578 33.7363 20.5387 -17.5006 5.04967 -0.0763559 +2515 4 24.6934 34.6555 20.8512 7.60819 -4.12262 3.6003 +2516 4 23.9235 33.6132 20.0554 5.3121 -3.42637 -1.44671 +2517 6 41.6963 16.3109 0.897802 2.88421 10.066 -28.0255 +2518 4 41.3077 16.0362 1.70176 -16.3219 -5.78099 30.2108 +2519 4 42.6299 16.1901 1.06805 12.6035 -3.11322 -2.97519 +2520 6 23.404 27.9303 27.4821 -1.06023 20.2241 -21.3645 +2521 4 22.8141 28.2554 28.1835 2.551 -1.87769 -8.73241 +2522 4 23.2629 28.4828 26.6516 2.17993 -16.4871 31.3925 +2523 6 32.7813 37.2936 18.7328 38.5641 -14.7697 6.75932 +2524 4 33.752 37.1016 18.9061 -34.9795 -0.437252 0.892363 +2525 4 32.8311 38.1729 18.3762 -6.70298 14.6722 -8.07554 +2526 6 21.2305 27.6771 4.7955 -18.4608 -25.795 -24.9287 +2527 4 20.5062 27.4644 5.39651 2.92048 5.31567 1.45057 +2528 4 20.941 27.2184 3.94502 12.5509 18.4099 23.8236 +2529 6 54.9409 17.9571 1.83459 -7.07205 6.42915 6.55936 +2530 4 54.7029 17.1381 1.42965 7.06691 -21.815 -7.49321 +2531 4 54.119 18.4405 1.74821 -9.38537 8.8513 -0.363257 +2532 6 36.7335 10.6984 6.58912 -34.5362 -0.324761 -4.53473 +2533 4 35.7609 10.9799 6.6143 34.1258 -12.1011 2.72213 +2534 4 36.7696 9.77633 6.90859 -3.13742 6.31851 -1.30765 +2535 6 54.2706 4.50024 14.0257 -11.269 5.99606 -15.4247 +2536 4 53.8536 5.11876 13.3604 4.87759 -11.992 26.1673 +2537 4 53.895 4.59469 14.9192 -3.76531 8.72829 -7.53187 +2538 6 22.107 12.8255 32.0148 27.0088 -6.82073 4.3703 +2539 4 21.2061 13.1328 31.8952 -10.7145 6.62508 -9.34344 +2540 4 22.7298 13.2576 31.3917 -17.4011 -3.99159 8.00208 +2541 6 15.2931 36.6619 4.04206 -24.4039 12.3238 20.1693 +2542 4 15.3606 37.6342 3.9855 6.08423 -9.62309 -2.22716 +2543 4 16.0243 36.2999 3.55051 12.1414 -1.28609 -8.9598 +2544 6 23.9518 1.27347 5.70825 1.82336 16.8815 15.3992 +2545 4 23.158 0.731739 5.71694 -5.31944 -7.03749 -3.2154 +2546 4 23.9846 1.73289 6.57368 -1.26671 -8.46254 -14.2674 +2547 6 14.3069 12.6571 15.8074 -11.3886 -13.8779 -22.9988 +2548 4 14.4908 12.4438 14.8835 17.1875 4.58775 1.43504 +2549 4 13.3991 12.3171 15.8566 5.60683 8.95198 18.2444 +2550 6 15.0463 40.2277 6.58272 -14.4539 15.1029 5.15073 +2551 4 15.8086 40.489 7.08192 22.3652 -6.01515 7.9389 +2552 4 14.4962 41.022 6.75392 -6.77819 -16.9793 -13.6053 +2553 6 48.5629 32.6194 12.091 2.37027 -5.84764 -3.4739 +2554 4 48.1048 31.8776 11.6348 7.57669 12.4587 1.43975 +2555 4 49.3373 32.9111 11.5511 -18.0393 -12.2542 5.39731 +2556 6 11.2883 31.5349 7.21941 -5.75599 -10.1169 -16.3625 +2557 4 10.675 30.8987 6.79271 12.7122 10.5617 8.56414 +2558 4 11.681 32.0415 6.48473 -4.52974 -6.63428 7.17241 +2559 6 30.1204 27.9925 10.216 2.65146 5.67665 0.571004 +2560 4 30.7332 28.7325 10.019 -7.63861 -11.6097 -0.594568 +2561 4 29.9063 27.5181 9.39417 2.857 4.22172 -1.33476 +2562 6 27.6817 22.1076 17.3717 2.13561 -8.21554 7.46684 +2563 4 27.3138 21.4721 16.7296 5.88092 9.15558 -3.1228 +2564 4 28.0594 22.8778 16.9197 -3.27829 -5.84867 -5.86393 +2565 6 12.9588 4.5965 18.1625 2.45174 -26.8216 -12.137 +2566 4 13.4346 3.75914 18.3684 -5.38503 16.4797 0.486183 +2567 4 12.5704 4.4145 17.2814 1.35975 11.1796 8.84538 +2568 6 19.7171 6.72206 19.0824 18.7149 18.1076 8.78634 +2569 4 19.0276 6.07043 19.1643 -12.8479 -14.7766 2.48779 +2570 4 20.149 6.78349 19.9504 -8.03044 -1.70313 -8.42964 +2571 6 37.158 31.386 11.4948 13.5333 -6.17925 -0.534196 +2572 4 36.3748 31.5241 12.0574 10.6691 -10.2998 8.4252 +2573 4 37.8298 30.7884 11.9154 -26.2348 9.80485 0.777976 +2574 6 3.12167 16.2038 27.3537 -19.2499 -26.3416 -14.9115 +2575 4 2.564 15.4232 27.613 17.9651 21.4634 -3.17821 +2576 4 3.05771 16.2343 26.3741 -0.0558506 5.44355 20.7735 +2577 6 15.7152 9.97508 38.3617 37.2659 20.4939 22.6587 +2578 4 16.1689 10.8384 38.1525 -17.0523 -25.976 5.55091 +2579 4 16.2475 9.64647 39.1327 -18.0975 2.21635 -20.7757 +2580 6 13.3945 14.2914 8.22355 52.7406 24.0557 20.8129 +2581 4 13.9343 15.0997 8.53617 -32.8018 -27.7376 -11.9171 +2582 4 14.0669 13.5802 8.35008 -24.0553 1.67412 -6.96019 +2583 6 1.72299 24.3133 36.3936 32.5837 -28.3335 21.1288 +2584 4 1.96116 25.1215 36.8464 -1.44419 12.4956 -1.11134 +2585 4 1.10799 24.5417 35.7277 -24.491 15.1488 -24.3141 +2586 6 11.1925 26.5189 32.9725 1.88857 3.23229 20.5962 +2587 4 10.9062 26.8258 32.1286 -6.138 -2.28585 -27.1412 +2588 4 11.0637 27.2989 33.5293 3.02186 -7.15206 7.83107 +2589 6 29.5898 0.769141 36.29 0.770047 10.6645 18.3277 +2590 4 29.1085 0.54227 35.5145 -3.81283 -13.529 -27.0487 +2591 4 28.8904 1.11515 36.8518 6.86702 4.29265 4.12775 +2592 6 43.6054 13.1224 23.9122 -2.46968 6.93561 -17.1322 +2593 4 42.8447 13.3401 24.4619 -4.47847 1.10283 0.728731 +2594 4 43.3126 13.2067 22.9653 4.50753 -0.208477 27.3689 +2595 6 7.45217 19.7807 19.6677 5.33955 -1.6221 -12.877 +2596 4 6.80427 19.1226 19.9251 -3.45906 -4.13396 8.35684 +2597 4 7.46466 19.745 18.7046 0.226191 5.91599 3.73904 +2598 6 24.4186 4.28854 7.83154 -9.27237 -3.93777 -5.86373 +2599 4 24.1141 5.19611 7.95791 2.72117 -5.11917 -0.666563 +2600 4 25.0574 4.07609 8.5187 1.73531 2.38301 -0.0162684 +2601 6 51.4783 30.2365 31.1578 4.43663 8.1051 17.8753 +2602 4 50.5719 29.9409 31.3316 -1.01079 -0.531629 -9.26743 +2603 4 51.6665 30.2531 30.2149 -6.58635 -1.64064 -12.0931 +2604 6 0.928618 23.6677 16.8891 39.1558 -2.20072 16.2176 +2605 4 0.0728448 23.4362 16.5368 -6.93512 -13.3273 -6.91209 +2606 4 1.45563 22.867 17.1505 -20.9828 13.2836 -9.64814 +2607 6 45.0876 19.3948 15.692 7.86589 27.8079 -34.4593 +2608 4 45.9117 18.9264 15.546 6.38244 -8.87865 2.87525 +2609 4 44.6429 18.9609 16.3882 -19.7965 -22.2098 30.8606 +2610 6 17.4975 8.71947 40.5884 -15.3884 33.6574 -8.04213 +2611 4 18.1832 9.38307 40.741 -0.0730079 1.31818 -0.306908 +2612 4 17.9142 7.90906 40.8182 15.4372 -26.466 6.58932 +2613 6 30.1853 27.2566 27.195 -12.9952 17.3445 1.1523 +2614 4 31.1231 27.467 27.0889 -0.851996 0.391463 0.93648 +2615 4 29.6983 28.1205 27.2412 18.1484 -22.709 -4.59112 +2616 6 43.0643 26.2027 28.3545 -5.31946 22.0639 -20.7107 +2617 4 43.281 25.753 27.5201 1.76973 -3.45008 6.18356 +2618 4 43.0898 25.5645 29.0616 2.35339 -12.574 6.70826 +2619 6 27.9963 7.58777 3.05558 10.5798 9.34284 19.8534 +2620 4 28.0446 6.83168 2.47717 -2.58104 -14.3156 -10.0889 +2621 4 28.509 7.35692 3.86128 -6.64638 2.01122 -8.68086 +2622 6 44.6822 7.22369 10.1895 -15.4824 21.4485 13.7445 +2623 4 44.4465 7.45383 11.1264 7.27839 -9.51736 -18.1425 +2624 4 45.2115 6.42757 10.2073 4.94307 -7.89984 8.76143 +2625 6 23.5336 20.3897 32.2571 -4.86538 -1.36788 -16.1605 +2626 4 23.3032 21.2113 32.7104 1.28111 0.523216 5.34569 +2627 4 23.9774 19.8232 32.8948 2.81274 0.218846 6.19737 +2628 6 37.5478 21.0473 29.278 -18.5062 7.79735 6.57819 +2629 4 37.2371 20.358 28.6908 4.72073 -14.165 -12.1471 +2630 4 36.7158 21.4163 29.628 13.2175 4.90017 2.66375 +2631 6 49.286 29.0703 28.699 10.8186 8.22027 -9.31733 +2632 4 48.7028 29.7991 28.456 -10.3299 -0.414367 -0.610456 +2633 4 50.1517 29.4276 28.433 0.637469 -9.81751 4.99071 +2634 6 47.52 18.1671 15.2208 -2.7229 30.7912 -34.1138 +2635 4 48.0078 17.7317 15.8928 12.2019 -13.0526 25.5862 +2636 4 48.0044 19.0008 15.0204 -10.6208 -16.322 3.06818 +2637 6 23.2448 11.1727 16.5931 -14.8157 -11.6244 -0.308602 +2638 4 23.8342 11.8286 16.2582 11.4387 21.3683 -6.30591 +2639 4 23.6559 10.3501 16.3116 -3.14365 -5.23997 2.15847 +2640 6 3.13911 8.33446 23.1963 -2.69702 8.14317 3.16076 +2641 4 3.4034 7.82956 22.4196 3.11719 -1.75335 -2.44085 +2642 4 3.61355 9.18537 23.1574 -2.855 -3.87959 1.25156 +2643 6 0.502965 16.1866 6.18545 3.06312 3.24934 37.7622 +2644 4 1.47856 16.2897 6.04903 -24.0003 -4.70784 4.68468 +2645 4 0.309706 16.1237 7.18858 13.4295 2.89967 -42.1744 +2646 6 43.1771 15.7066 5.83749 -5.07319 -7.51407 -5.60477 +2647 4 43.0136 16.4204 6.43488 -7.5966 11.2789 14.4199 +2648 4 44.0623 15.8898 5.5251 15.5631 0.134699 -7.60204 +2649 6 16.7019 35.4798 34.4572 -11.2013 7.16284 28.6023 +2650 4 15.9782 34.9492 34.0738 5.35466 1.61493 8.45244 +2651 4 16.3895 35.7941 35.362 6.52255 -9.83405 -29.4813 +2652 6 38.8822 7.74245 15.6771 24.467 26.2162 11.5837 +2653 4 39.1941 7.06316 15.0707 0.325231 -3.95447 -5.25413 +2654 4 39.6937 8.2709 15.9758 -30.2905 -22.5291 -12.0432 +2655 6 42.0043 36.5204 13.6369 3.57579 19.2035 0.0265624 +2656 4 41.9371 35.5667 13.6578 -6.58441 -9.91584 1.38486 +2657 4 41.1548 36.8737 13.3269 0.670997 -7.61264 0.497391 +2658 6 54.2965 15.3698 32.1203 7.94984 -1.57724 11.6593 +2659 4 0.00278476 15.9714 32.4364 -1.97539 -6.90512 -0.0853595 +2660 4 53.6257 15.9484 31.7567 -4.83125 0.736868 -4.95397 +2661 6 22.8953 13.994 39.0277 29.317 0.766946 3.70607 +2662 4 23.2673 14.8115 39.3939 -3.87119 -6.48985 -1.20924 +2663 4 21.9724 14.1463 38.894 -27.0425 2.87882 -4.26486 +2664 6 48.0413 28.5291 4.79053 -11.6037 -2.58599 22.6989 +2665 4 48.6027 28.7991 4.07655 16.555 3.34212 -19.6439 +2666 4 47.7045 29.3636 5.15455 0.064426 -0.719185 3.47056 +2667 6 48.8324 10.6079 2.66689 -4.06073 -3.45613 -38.269 +2668 4 48.225 10.1372 3.21562 -13.339 -11.2438 14.6703 +2669 4 49.3888 11.1314 3.20945 16.7197 17.33 23.918 +2670 6 17.1017 29.3417 4.42129 -6.1746 1.2215 19.6287 +2671 4 16.2515 28.9749 4.73431 4.06151 0.983408 -5.41825 +2672 4 17.5169 29.7258 5.22535 1.37581 -6.66399 -13.2687 +2673 6 27.7925 7.31966 26.5665 39.3465 35.5797 -5.30427 +2674 4 28.7629 7.09708 26.703 -34.5848 -6.71948 -0.628584 +2675 4 27.2286 6.57009 26.6643 -1.86949 -31.2701 4.24572 +2676 6 18.0221 22.0409 22.5172 -16.5701 10.2349 -21.3339 +2677 4 18.5639 21.2383 22.5163 -1.8186 -3.43948 -8.36361 +2678 4 17.5144 22.1102 21.6408 22.068 -10.0871 32.2991 +2679 6 22.1395 25.0891 16.7042 -20.9036 23.9116 7.05274 +2680 4 21.7854 25.6501 15.9625 11.5166 -19.4533 18.3362 +2681 4 22.5191 24.3092 16.3181 5.92374 -8.20656 -11.3677 +2682 6 25.488 28.4523 7.12785 -10.8823 -15.9396 20.8595 +2683 4 25.4981 28.5494 8.12476 3.48758 8.16016 -33.1398 +2684 4 25.5521 29.3092 6.69674 -1.4246 11.8198 7.49476 +2685 6 42.5416 24.7341 23.7389 -17.4504 20.5814 2.46415 +2686 4 41.7374 25.1978 24.1118 21.637 -12.0739 -8.95046 +2687 4 42.3838 23.7928 23.8344 -7.43983 -12.597 1.84916 +2688 6 6.22002 16.6178 2.47863 15.1987 22.5956 5.3052 +2689 4 5.33799 17.0017 2.41879 -13.1624 -14.3434 -0.0608379 +2690 4 6.24934 15.6649 2.55192 -10.5885 -12.312 -0.729605 +2691 6 47.3735 33.281 1.45237 -1.26376 -9.34891 -34.4477 +2692 4 47.004 34.1558 1.53803 -0.151384 8.42018 6.19826 +2693 4 47.7374 33.0316 2.29181 5.29029 2.56444 17.845 +2694 6 1.28124 36.1882 24.8833 15.6174 10.404 -23.7919 +2695 4 0.591937 36.4933 25.4703 -7.67557 -4.15788 11.0948 +2696 4 1.63511 35.375 25.2549 -3.92235 -3.89482 10.8998 +2697 6 20.9296 29.0485 16.4244 -14.8946 8.72798 0.140185 +2698 4 21.4494 28.4837 15.8729 6.14594 -21.5718 -11.6475 +2699 4 21.5122 29.7657 16.643 5.64358 11.2813 6.66084 +2700 6 18.6504 32.5428 14.1464 30.5599 1.70581 -2.73789 +2701 4 17.8579 33.056 14.2705 -20.3424 -4.20043 8.80032 +2702 4 18.5989 31.5954 14.3835 -16.0449 10.8642 1.76069 +2703 6 15.729 41.6925 0.00385817 -5.28292 -15.868 -0.0471225 +2704 4 15.6317 41.084 41.1283 -1.722 11.921 23.9575 +2705 4 15.1873 41.3899 0.782005 8.67232 1.52126 -23.9336 +2706 6 20.5292 18.4098 7.21323 -2.91221 4.89049 5.17577 +2707 4 20.2914 18.5583 8.16487 -5.028 -0.721877 -18.2737 +2708 4 19.7413 18.3526 6.62958 8.30767 0.291632 18.8261 +2709 6 35.3342 2.82915 1.61883 3.51298 26.3767 19.1091 +2710 4 35.0331 3.19583 2.50754 16.3791 -7.36031 -35.2043 +2711 4 35.9206 3.53855 1.22039 -16.4006 -18.5858 14.5973 +2712 6 48.9922 19.6721 24.94 -34.075 0.0390245 -1.22883 +2713 4 49.8199 19.2352 24.7823 16.5976 -0.114011 -0.96393 +2714 4 49.1617 20.6125 25.0649 5.94448 -3.86752 4.03728 +2715 6 26.0294 7.18427 41.5679 18.6543 -22.0446 -14.9111 +2716 4 26.7755 6.56315 41.735 -11.6555 11.6244 -4.08136 +2717 4 25.6575 7.3193 0.515359 -11.3234 5.2253 22.1616 +2718 6 22.0232 3.61039 29.0191 -5.74486 -2.38085 -7.46091 +2719 4 21.2539 3.82496 28.4513 11.98 3.27859 6.66273 +2720 4 22.2148 4.35673 29.5966 -4.60401 3.08527 0.791206 +2721 6 27.8512 32.5337 20.6565 16.709 -10.0789 14.6393 +2722 4 26.9625 32.7469 20.4552 -34.4793 1.21347 -3.16249 +2723 4 28.3469 33.1233 20.1026 12.1012 5.18966 -5.24336 +2724 6 8.41229 24.7869 3.46082 22.3386 15.1563 9.53263 +2725 4 8.90357 24.2552 2.84068 9.55631 -8.44952 -10.853 +2726 4 7.60423 24.3318 3.61908 -22.8615 -12.1417 2.22131 +2727 6 30.5897 41.7312 15.6484 22.6974 7.2585 28.5546 +2728 4 29.9644 0.0840213 16.3484 1.9076 -3.76769 -8.41354 +2729 4 30.1014 41.5664 14.8669 -20.7398 -7.21626 -25.2002 +2730 6 48.088 5.62638 21.1953 6.60529 -8.20232 0.106871 +2731 4 47.6746 6.34733 20.7055 -8.23977 -5.05625 1.96425 +2732 4 47.4017 5.06013 21.5879 -0.150274 10.975 -6.21391 +2733 6 39.4216 23.1741 35.7526 -24.6601 -13.9913 -21.1364 +2734 4 39.9113 23.6202 36.3986 28.8985 24.9348 33.8823 +2735 4 38.8958 22.5444 36.2533 -4.57276 -5.65639 2.90172 +2736 6 51.5794 33.3637 5.78804 -15.2387 -43.0642 -16.4958 +2737 4 51.7543 34.264 5.94613 8.32006 43.2545 8.99501 +2738 4 51.5314 33.243 4.82206 1.27667 3.09716 8.04215 +2739 6 40.1245 17.6149 30.7901 8.56984 -3.86721 -1.09973 +2740 4 39.7659 18.4612 31.0527 -2.58034 0.199434 5.42908 +2741 4 40.7245 17.8709 30.0792 -0.880063 -10.8459 -3.09375 +2742 6 46.409 9.80599 18.5787 -10.6525 10.5445 16.3312 +2743 4 47.1858 10.3579 18.4839 1.73901 1.20814 1.97642 +2744 4 46.4156 9.2339 17.8265 -1.18405 -17.3223 -19.0152 +2745 6 15.8964 41.084 31.9275 -7.67529 -16.3413 6.36199 +2746 4 16.5726 40.6297 31.3851 0.744388 15.1086 2.48527 +2747 4 16.0838 0.121849 31.9545 10.6182 0.477469 -6.79561 +2748 6 48.5579 25.7373 14.9245 -32.9201 0.62376 14.4593 +2749 4 49.4842 25.8337 14.7718 19.5896 2.21134 -17.0603 +2750 4 48.049 25.8802 14.1037 15.4245 2.93063 1.46628 +2751 6 39.2312 28.9787 36.1455 -14.672 -4.00104 3.01304 +2752 4 39.9934 29.3216 36.628 6.25522 6.25199 -7.03146 +2753 4 39.4638 28.7366 35.2366 10.4577 0.0924929 -3.6403 +2754 6 37.3289 21.0516 14.9314 -10.8689 -7.09111 1.49701 +2755 4 38.071 20.892 14.3011 -28.0288 10.0477 -1.14031 +2756 4 36.4673 21.3942 14.5393 36.2132 -8.93414 7.14583 +2757 6 32.4934 22.8531 15.7417 3.10645 -11.4389 20.7178 +2758 4 31.7266 22.539 15.2235 4.17967 -1.79737 6.20971 +2759 4 32.6084 22.2825 16.5528 -7.19864 12.5613 -26.7488 +2760 6 18.5678 8.15053 37.5885 12.1963 17.253 1.38788 +2761 4 19.2402 8.85275 37.7813 -15.6951 -12.294 2.78452 +2762 4 17.9606 8.11124 38.3342 2.60008 5.05619 4.87993 +2763 6 46.9436 30.3797 11.0104 1.88703 -1.83756 -2.66296 +2764 4 46.4577 30.6986 10.2121 16.8565 -15.5671 12.8865 +2765 4 47.4104 29.5424 10.7815 -11.8828 15.01 -3.66074 +2766 6 54.6316 13.0448 30.6676 -4.47091 -6.8042 2.85617 +2767 4 54.8929 12.2323 31.1402 -1.2342 7.60269 0.15722 +2768 4 54.6603 13.771 31.309 -0.297949 0.849652 -1.52079 +2769 6 32.2951 35.1224 27.9786 -1.77947 21.9995 15.3623 +2770 4 32.2792 35.8643 28.662 -2.01418 -27.5067 -15.3374 +2771 4 32.1621 34.2527 28.3767 0.559318 -0.0892981 14.8897 +2772 6 4.45055 25.4036 31.7899 -1.02142 -16.2715 16.4968 +2773 4 4.99753 24.9958 32.4777 -6.33224 -6.47315 3.67169 +2774 4 4.91071 26.2154 31.6821 9.55032 31.2277 -12.9728 +2775 6 40.7771 38.1434 21.8579 6.80518 1.6634 -4.63259 +2776 4 40.7449 39.0581 22.1203 -10.5616 15.8809 15.9679 +2777 4 41.4448 38.2055 21.1733 6.63637 -13.627 -11.1518 +2778 6 26.6799 9.85647 27.3982 -25.6987 30.8747 18.2417 +2779 4 27.0738 9.12687 26.9584 7.64189 -30.2216 -11.3166 +2780 4 25.7862 9.62595 27.7363 13.5029 -2.01996 -6.34848 +2781 6 53.4177 39.431 11.7682 60.4327 6.90374 -14.3662 +2782 4 54.4363 39.4906 11.5459 -51.7213 -2.15349 13.0324 +2783 4 53.0514 40.2823 11.4531 3.65586 -10.6921 6.91198 +2784 6 35.3318 21.4177 2.24537 5.41769 -12.1321 -20.1082 +2785 4 34.8431 20.6225 2.51379 1.47903 7.83344 1.83382 +2786 4 35.7036 21.1864 1.3528 -11.9529 6.47568 24.5243 +2787 6 4.13637 17.136 33.9211 3.37621 -12.3766 5.67686 +2788 4 4.20441 16.396 34.5697 -7.88327 11.3141 -11.775 +2789 4 3.23668 17.1493 33.5445 4.32036 -6.23827 5.33579 +2790 6 24.1551 16.173 14.6595 0.905264 -13.203 -15.7913 +2791 4 24.2344 17.0724 14.9677 3.21898 8.1818 3.14137 +2792 4 23.7074 16.2777 13.8038 1.81958 -4.41422 2.08172 +2793 6 43.135 2.84466 26.1032 13.1229 6.35408 -5.68313 +2794 4 42.2875 3.17639 26.414 -4.49653 4.08553 -4.30298 +2795 4 43.2684 3.17059 25.1875 -5.24638 -3.17663 12.7173 +2796 6 40.6938 12.184 1.56501 -11.5288 -7.07153 -25.6549 +2797 4 41.6237 12.1687 1.8186 -0.151998 5.09311 17.9246 +2798 4 40.0653 12.4844 2.24465 11.7671 0.703669 4.7582 +2799 6 47.3771 8.09383 26.755 61.1653 27.2124 16.0462 +2800 4 46.6352 7.69428 26.3774 -33.8593 -24.2939 -29.8281 +2801 4 48.1554 8.02079 26.1437 -24.5213 -4.41693 14.2109 +2802 6 35.8722 30.7298 38.4929 46.7797 8.20249 -0.795626 +2803 4 35.8437 29.9971 39.0885 -23.8052 -20.0767 8.1402 +2804 4 36.8495 30.8926 38.5637 -31.083 11.8011 -18.5205 +2805 6 51.2951 23.2205 32.4921 -21.4102 17.5258 -2.96787 +2806 4 51.6315 24.0445 32.1105 -0.705735 5.94923 -0.836877 +2807 4 52.0737 22.714 32.6486 16.7198 -16.4886 4.04233 +2808 6 30.6141 4.4461 39.6711 -15.3731 3.79473 -35.0115 +2809 4 30.9464 3.61986 40.0176 9.77962 -4.83986 19.2734 +2810 4 30.7704 5.18568 40.2576 9.11216 5.26318 14.244 +2811 6 35.2646 29.7051 2.85778 -14.8887 -12.395 -20.7058 +2812 4 35.7986 29.7272 2.02588 -11.2321 -1.99949 14.2373 +2813 4 34.4405 29.1492 2.64359 32.9241 21.0754 6.44042 +2814 6 50.3111 26.1454 9.40098 -22.1621 10.9454 -20.0185 +2815 4 49.986 26.7793 8.71172 15.2241 -16.6208 13.1315 +2816 4 49.7063 25.388 9.31525 11.793 4.08785 3.97386 +2817 6 50.0869 36.8245 26.4088 -20.9012 -6.38176 7.71076 +2818 4 49.5586 36.0705 26.7514 3.9746 5.79943 -8.74909 +2819 4 50.1941 37.3864 27.1871 4.41306 8.36789 0.548966 +2820 6 40.3119 23.9565 38.5384 47.4279 -1.39254 -15.5521 +2821 4 40.88 24.732 38.748 -21.3925 -13.0784 -2.40019 +2822 4 39.4343 24.1145 38.8527 -20.1214 13.5622 11.7594 +2823 6 24.9444 10.7496 30.6663 31.051 18.5451 27.0394 +2824 4 25.7305 10.8456 31.2787 -28.4 -7.1047 -26.2292 +2825 4 24.8995 11.6269 30.2371 -7.15612 -14.1049 -2.61146 +2826 6 5.89131 1.01728 5.39947 -5.16247 -17.9253 -0.227043 +2827 4 5.22088 0.340863 5.59281 2.49468 7.88844 1.50452 +2828 4 6.71299 0.544267 5.57411 4.99832 4.76302 -4.28882 +2829 6 44.2927 29.3807 26.2764 43.728 -18.4205 -0.18667 +2830 4 43.5018 29.5461 25.816 -39.4067 7.83222 -12.62 +2831 4 44.7851 28.7616 25.699 -3.50466 6.32584 16.51 +2832 6 25.3064 10.1814 6.6654 -6.94402 -15.718 -9.61204 +2833 4 25.6542 11.0594 6.61048 6.10034 18.8978 1.37462 +2834 4 25.5624 9.77067 5.8255 0.943829 -2.29537 1.40094 +2835 6 13.3606 28.0664 2.58456 21.0736 -2.27515 1.79417 +2836 4 12.4645 27.8304 2.42125 -25.9451 -0.745297 2.44011 +2837 4 13.7867 27.7237 1.79619 10.8353 3.06046 3.23802 +2838 6 6.45257 40.24 18.0133 20.0379 8.33657 1.98834 +2839 4 6.89988 39.3931 17.8777 -5.14522 -3.62214 0.392952 +2840 4 5.56311 40.1207 17.6969 -15.0406 -3.82351 -6.06839 +2841 6 47.8011 13.5056 2.01844 -10.5648 -21.267 23.3214 +2842 4 48.1524 12.6081 2.17165 -2.87721 6.43796 -2.24674 +2843 4 48.4275 13.9546 1.48105 20.9852 11.6376 -18.273 +2844 6 13.5939 20.3067 2.43603 17.8956 14.689 14.157 +2845 4 13.8339 19.6256 3.09172 -4.40777 3.66463 -6.9739 +2846 4 12.9598 19.9059 1.86118 -14.8369 -10.3601 -11.305 +2847 6 15.2334 0.8368 36.6591 1.55142 7.70692 -22.3998 +2848 4 15.2542 1.38367 37.4773 0.960764 -3.32816 -20.1037 +2849 4 15.3344 1.45306 35.8608 -4.23652 -17.7771 37.8382 +2850 6 33.6147 35.2459 15.1 16.7734 -11.8793 -18.4599 +2851 4 33.8163 35.2873 16.0538 13.2499 -3.34836 -12.9991 +2852 4 34.4154 34.9808 14.5294 -23.6504 9.8312 34.8639 +2853 6 21.8005 9.23588 0.431159 13.8262 -19.7524 30.0596 +2854 4 22.4067 9.05801 41.6249 5.27322 -0.932182 -12.5411 +2855 4 21.1072 9.74412 0.0564903 -22.836 18.1195 -16.0408 +2856 6 38.1565 27.4627 3.04439 18.4183 -28.2807 7.84104 +2857 4 37.7322 27.3164 2.21113 -4.60599 -14.2952 -24.3043 +2858 4 37.7632 28.2451 3.34335 -13.6136 36.2365 19.5187 +2859 6 38.8873 27.196 11.7739 15.5044 -8.33717 -5.93911 +2860 4 38.7841 26.3327 12.232 6.37868 6.61944 -11.5261 +2861 4 39.5786 27.1133 11.0659 -17.5863 -8.28826 19.2684 +2862 6 29.8757 41.5959 28.7066 13.5858 28.49 -11.3766 +2863 4 28.9647 41.3014 28.7466 -9.40406 -2.02578 1.88502 +2864 4 29.8997 0.254331 27.9025 -2.68961 -11.7418 13.302 +2865 6 34.0266 8.72323 38.0698 33.719 9.40995 4.6971 +2866 4 34.8877 8.24089 38.094 -11.378 13.1352 -1.62724 +2867 4 33.3712 8.08689 37.8245 -20.4874 -15.945 -8.86187 +2868 6 38.8142 27.3472 30.6886 -7.48306 -22.0573 -0.58069 +2869 4 38.4096 26.5151 30.3537 9.19692 16.3236 1.53567 +2870 4 38.2655 27.5885 31.4334 -4.0026 6.56393 5.14207 +2871 6 41.6513 17.2644 36.3568 8.49285 18.5772 4.12306 +2872 4 41.236 17.1887 35.5016 -7.55839 -3.54967 -10.3568 +2873 4 41.7813 16.3888 36.7033 1.22956 -17.0266 1.65102 +2874 6 30.7157 26.9788 35.2038 -10.151 -4.28381 0.0670681 +2875 4 31.4488 27.4236 34.7965 20.0965 0.384289 -13.2747 +2876 4 30.343 27.6484 35.7639 -8.80839 6.96039 12.3672 +2877 6 47.5342 4.10778 27.2888 11.6095 8.93875 26.3727 +2878 4 46.6105 4.27591 27.501 -8.38331 -0.425724 -4.8003 +2879 4 47.5988 3.99389 26.3497 -6.2541 -0.220522 -17.1995 +2880 6 20.9412 8.38521 7.26575 -18.1268 -17.2637 2.68033 +2881 4 20.8809 8.87169 8.08328 -6.592 1.96128 21.9757 +2882 4 21.4179 8.98778 6.73029 19.5174 18.1449 -30.7672 +2883 6 36.8608 13.6781 0.872276 -22.567 18.0135 -7.8322 +2884 4 37.3857 13.5342 1.64823 18.2236 -14.2068 17.6988 +2885 4 36.9649 12.9376 0.269125 7.56106 -9.0363 2.17502 +2886 6 28.5805 20.3012 26.4498 13.4935 0.222411 -13.7489 +2887 4 28.4835 19.3803 26.2016 0.90122 -3.21423 2.30104 +2888 4 27.7964 20.5416 26.9224 -18.5183 5.12398 12.3317 +2889 6 51.6021 16.8515 33.5179 -11.2544 -15.3 0.627003 +2890 4 51.563 16.0241 34.0301 0.916298 4.09207 -0.753195 +2891 4 51.0058 16.6639 32.7753 6.31462 4.20327 -0.345536 +2892 6 16.2626 32.019 37.6812 -31.2107 -29.2496 -22.9287 +2893 4 16.4537 31.3803 38.4011 -2.23747 12.829 -12.3594 +2894 4 15.5373 31.5705 37.1079 31.9743 21.1891 23.5065 +2895 6 14.3366 25.8859 13.2055 -16.2598 35.1345 -7.65407 +2896 4 13.5591 26.1022 13.7538 4.79106 -9.45955 4.66587 +2897 4 14.3924 26.7004 12.6499 8.67511 -16.0651 4.90492 +2898 6 54.9632 28.863 3.30225 1.80665 -46.0259 4.02989 +2899 4 54.8334 28.8705 2.33571 2.30679 -1.29159 7.0988 +2900 4 0.250446 27.9134 3.53944 -11.9885 37.0888 -10.0107 +2901 6 17.2065 5.13222 2.58226 -24.5489 -19.7693 -14.9516 +2902 4 17.8239 4.45011 2.8785 5.4716 1.45995 5.40018 +2903 4 17.4096 5.93537 3.0482 10.2082 3.99522 6.08435 +2904 6 50.7076 33.0524 10.3335 3.48719 10.0002 9.95533 +2905 4 50.6136 33.804 9.75033 0.0726689 14.8217 2.89741 +2906 4 50.6632 32.3255 9.72979 -1.7797 -23.5385 -6.20373 +2907 6 28.8719 19.8379 32.3662 12.2168 9.43689 -9.94144 +2908 4 29.8293 20.0527 32.223 -26.7315 -2.75674 4.09206 +2909 4 28.3919 20.677 32.2058 6.96369 -8.55206 2.54368 +2910 6 22.4258 12.8301 23.3099 -21.9068 12.8519 23.6974 +2911 4 22.5424 12.4187 24.2055 -3.2327 9.70973 -17.8182 +2912 4 21.6904 13.4906 23.4219 18.0295 -16.5223 -3.23075 +2913 6 54.7859 15.5473 8.87871 3.42684 8.57095 -7.37477 +2914 4 0.5152 15.244 9.45304 -3.41058 -4.28924 6.32649 +2915 4 53.9742 15.1056 9.16818 6.16615 -2.4265 3.01646 +2916 6 10.455 19.2982 26.169 33.281 -8.93788 40.2277 +2917 4 11.227 18.6906 26.1605 -15.5014 12.2348 -4.03004 +2918 4 10.0694 19.2521 25.3251 -19.4777 -1.76614 -41.28 +2919 6 38.6541 20.3016 35.2246 25.1317 -2.89776 0.584273 +2920 4 39.6122 20.389 35.0245 -16.8563 1.20482 1.7302 +2921 4 38.6037 19.6498 35.9401 -3.42784 5.37932 -3.92632 +2922 6 17.4847 18.0451 15.2473 -2.11698 43.6037 15.5575 +2923 4 17.3165 17.6253 14.4157 -4.81229 -12.7227 -25.2707 +2924 4 17.3243 19.0143 15.0283 6.45297 -29.0578 8.37137 +2925 6 29.6412 0.96029 26.2538 -2.92598 -32.1867 -14.968 +2926 4 29.2295 1.80722 25.9783 -5.05853 -19.2177 -5.0061 +2927 4 29.2302 0.136786 25.7855 11.2507 47.838 14.1271 +2928 6 30.4583 12.6781 28.2933 9.80318 -11.3268 12.128 +2929 4 29.9046 13.1756 27.6811 -9.35495 -4.05719 -6.55314 +2930 4 30.1425 11.7563 28.3949 -4.92949 12.905 -7.65094 +2931 6 36.6582 22.1039 33.3564 18.5548 3.44171 -30.7077 +2932 4 37.613 21.8793 33.4826 -21.695 5.78572 4.26475 +2933 4 36.1698 21.8632 34.1249 -2.38139 -6.6943 29.4942 +2934 6 34.851 22.4634 14.295 34.3706 -12.4795 -36.6647 +2935 4 34.1306 22.5878 14.8998 -26.9044 -0.864951 1.69223 +2936 4 34.6097 22.0485 13.4154 -10.7342 10.9778 31.0087 +2937 6 15.5278 9.60588 7.43972 42.9889 -30.8008 -13.2318 +2938 4 16.5289 9.52064 7.17624 -51.4641 3.68278 11.9177 +2939 4 15.1523 8.68078 7.51431 10.3517 24.0811 1.24627 +2940 6 21.8097 28.0449 19.8036 -9.3837 2.2861 -3.69714 +2941 4 21.8234 28.4749 20.6579 1.49564 5.45585 8.79124 +2942 4 20.892 27.7474 19.715 3.3935 -2.50466 0.747966 +2943 6 34.5377 24.4067 2.43307 17.6783 -35.0943 7.08511 +2944 4 34.5604 23.3833 2.29911 9.6022 45.0517 12.0591 +2945 4 35.2671 24.6922 3.07368 -22.5652 -15.0324 -19.8681 +2946 6 12.5974 20.9324 33.5156 -46.2472 -18.3539 -4.34371 +2947 4 11.7028 20.621 33.8238 24.9199 8.0821 6.3307 +2948 4 12.4411 20.8933 32.5604 17.1824 5.4367 5.76912 +2949 6 45.7726 31.1546 8.70236 -14.9606 25.5026 -0.599968 +2950 4 45.9029 32.1319 8.75243 4.68257 -18.3747 -3.63409 +2951 4 44.8252 31.0158 8.86685 6.58294 -2.27884 -1.49072 +2952 6 15.4856 22.546 30.183 -27.3843 -7.95278 -8.87715 +2953 4 16.2041 23.1276 30.4314 15.0704 -4.03687 4.09321 +2954 4 15.7065 21.6006 30.174 10.2057 11.8959 3.83923 +2955 6 39.7496 17.1848 38.4183 10.7213 7.86871 6.49434 +2956 4 39.4778 16.5926 37.6964 5.17631 5.73732 3.80123 +2957 4 40.5328 17.6892 38.1152 -12.3514 -12.5856 -1.70264 +2958 6 14.0114 24.6894 0.67727 2.36324 3.45559 -2.63023 +2959 4 14.2236 24.5974 1.61702 0.728832 5.12592 -0.706901 +2960 4 14.3876 25.5307 0.374588 3.08684 -2.75846 6.71077 +2961 6 31.517 19.5744 3.57234 -39.7066 16.7987 -9.47084 +2962 4 30.9812 19.3042 4.35775 22.6375 1.42354 -10.5596 +2963 4 32.4299 19.3292 3.64982 19.3858 -12.3464 7.87151 +2964 6 36.0836 25.0594 19.4567 -36.7914 6.39304 28.0525 +2965 4 37.0156 25.1955 19.4145 23.7106 3.97855 -3.98164 +2966 4 35.8434 24.7134 18.6052 0.797557 -6.28507 -17.3783 +2967 6 51.6689 17.6827 14.8094 17.1445 12.5774 26.8045 +2968 4 51.9037 18.5572 15.2299 -9.72171 -22.1194 -12.5657 +2969 4 51.1779 17.9239 14.0295 -8.26923 9.08158 -15.405 +2970 6 37.7112 27.5006 38.1887 12.9616 35.4771 9.449 +2971 4 37.6633 26.7956 37.5532 1.11487 -12.4995 -15.1422 +2972 4 38.1924 28.2458 37.7567 -11.1334 -22.4905 3.32353 +2973 6 34.7974 13.8528 30.7792 38.2139 14.8122 -13.8353 +2974 4 35.0479 14.6237 31.2931 10.1718 6.91547 -1.09557 +2975 4 34.0108 13.6012 31.1887 -47.9834 -23.6229 17.9792 +2976 6 19.6227 37.378 39.9679 -4.73731 -6.94245 -18.3615 +2977 4 20.5687 37.4692 40.1123 7.88808 5.09103 7.87528 +2978 4 19.5641 36.8976 39.1176 -6.21843 3.50671 7.67834 +2979 6 40.9479 34.0678 21.4433 -0.249567 -14.1225 -18.8789 +2980 4 41.1016 33.9428 22.3797 -2.14769 -1.67588 5.36328 +2981 4 40.6839 33.1793 21.1286 -1.36491 12.9737 -0.808456 +2982 6 32.9563 27.2052 26.5619 16.765 25.3633 38.6423 +2983 4 33.6584 27.782 27.0193 -28.2502 -21.1678 -18.3317 +2984 4 33.3196 26.985 25.7164 10.2198 -2.00428 -21.725 +2985 6 24.4119 18.6722 15.6191 2.60565 2.56356 0.790403 +2986 4 23.5591 19.1036 15.7005 -5.06369 4.62453 -0.705819 +2987 4 24.5532 18.2558 16.4735 3.02917 -4.75652 8.16225 +2988 6 29.9677 1.63803 9.07283 -8.6377 39.5876 -9.34009 +2989 4 30.0634 0.720354 9.20948 2.18912 -36.9171 5.61628 +2990 4 29.1461 1.70687 8.54641 9.48634 -0.985828 6.78106 +2991 6 31.4838 20.0989 7.86304 35.53 0.0326438 -30.7549 +2992 4 32.0429 19.6076 7.17649 -26.3889 9.76992 30.1887 +2993 4 30.8408 19.4752 8.19414 -7.49558 -12.7978 -1.24617 +2994 6 35.0504 3.77818 33.2765 0.0823497 -0.922868 12.9261 +2995 4 34.3448 4.25588 32.7981 8.7563 -3.59111 2.91721 +2996 4 34.8655 3.9194 34.2319 -2.64551 -3.11561 -17.2257 +2997 6 43.9652 7.96842 12.9746 -1.99776 -12.8019 0.966431 +2998 4 43.3695 7.30717 13.3748 13.3395 3.08022 -2.86187 +2999 4 43.3917 8.71398 12.8108 -3.39849 12.2944 -1.42541 +3000 6 44.1076 32.6848 16.9531 4.83347 14.0385 -4.8226 +3001 4 44.7886 33.3699 16.7553 -9.08835 -13.3706 7.91806 +3002 4 44.1269 32.547 17.9059 1.63547 3.97279 4.50154 +3003 6 40.604 27.1617 19.037 5.49217 0.683783 -24.0967 +3004 4 39.907 26.5243 18.7614 10.7357 10.4426 0.818988 +3005 4 41.0572 27.5561 18.2306 -16.7517 -14.1941 23.9583 +3006 6 46.0503 23.2068 29.0603 33.2935 27.7725 23.492 +3007 4 46.7239 23.8517 29.4252 -26.0483 -15.0892 -12.6312 +3008 4 46.5249 22.3737 28.9794 -1.25341 -9.22801 -2.13192 +3009 6 42.6264 30.606 18.8462 -34.271 -0.881878 -8.8004 +3010 4 43.5242 30.7893 19.1074 18.3218 -5.88078 -5.57768 +3011 4 42.5428 29.9264 18.1492 10.4183 2.57162 5.03187 +3012 6 36.1231 10.8975 23.2614 14.248 33.6052 6.96597 +3013 4 35.2264 11.248 23.1278 1.11349 -2.62395 -2.03304 +3014 4 36.6438 11.7125 23.5215 -18.5882 -27.5405 -10.5609 +3015 6 13.7387 31.5187 15.7175 -8.63655 -3.85126 -4.64142 +3016 4 14.6788 31.7096 15.8046 0.813603 4.25462 -2.48371 +3017 4 13.3439 32.0503 15.0041 7.14664 -1.81478 4.34843 +3018 6 33.1663 41.4263 27.7844 10.1514 -8.73892 50.1834 +3019 4 33.0558 0.0915148 27.0508 0.335607 20.6114 -25.4934 +3020 4 33.386 0.0476391 28.6 -4.59167 -12.6797 -24.4066 +3021 6 32.8924 22.9248 31.4777 14.8331 -14.2772 -3.0724 +3022 4 32.331 22.9976 30.6823 -4.11553 14.0534 8.76104 +3023 4 32.7731 23.648 32.1168 -12.639 5.72297 -14.9522 +3024 6 27.6514 16.8629 6.392 5.9792 -3.02818 28.7598 +3025 4 27.8554 17.3015 5.57876 -0.492343 9.99532 -20.1105 +3026 4 26.7867 16.4634 6.29535 -11.4685 -3.6273 -5.68351 +3027 6 47.2692 11.6326 26.0701 -7.51592 -12.561 -4.95541 +3028 4 47.0451 11.5188 27.0189 12.1951 16.3083 -15.426 +3029 4 47.7234 12.4489 25.7723 -5.45211 -2.19527 19.0308 +3030 6 27.5533 7.05227 7.64253 19.1893 -9.34804 28.5196 +3031 4 26.7486 7.45205 7.94122 -22.9318 8.15137 -1.85106 +3032 4 28.0959 7.04706 8.46187 -1.51515 -0.839126 -23.0353 +3033 6 39.7861 9.0687 11.9758 -15.1444 6.22431 -7.98147 +3034 4 39.495 9.25597 11.0599 4.77492 -2.72739 13.3066 +3035 4 38.9879 9.23938 12.5098 3.46881 -0.389139 -2.20355 +3036 6 18.1894 33.4728 36.1008 -27.5283 -9.1571 7.06889 +3037 4 17.6722 33.9726 35.425 4.94426 -9.47891 13.9641 +3038 4 17.5468 32.9442 36.6812 19.6546 19.0371 -24.2711 +3039 6 37.1945 26.5569 0.720807 -12.4444 8.19753 -2.53971 +3040 4 37.3568 25.6462 0.476597 4.7119 -6.04631 0.679389 +3041 4 36.2336 26.6328 0.585525 8.76389 3.8419 -0.879611 +3042 6 44.2004 19.6233 36.8917 26.7932 -13.3754 0.0595121 +3043 4 45.0387 19.0956 36.766 -19.227 18.7818 5.02367 +3044 4 44.4376 20.5683 36.9644 1.27086 -9.01627 -1.91077 +3045 6 27.7799 6.35317 35.6882 16.2858 -3.70231 1.18314 +3046 4 27.1634 6.96571 35.2926 -9.46908 3.45363 -4.90602 +3047 4 27.3042 5.53742 35.858 -2.00694 0.00942349 2.38052 +3048 6 34.7653 16.4924 20.8795 20.4023 -19.0949 10.3746 +3049 4 35.5516 15.8729 20.9898 -30.5098 25.2475 -4.70775 +3050 4 34.1298 16.2162 21.5757 7.90375 5.70636 -13.0995 +3051 6 39.0303 20.9673 40.4307 -20.4786 -67.2325 12.8224 +3052 4 38.8254 20.089 40.9106 11.5443 40.6977 -30.184 +3053 4 39.2642 21.5386 41.1412 8.11615 27.562 18.514 +3054 6 10.8068 27.9205 1.65866 27.4379 7.91142 -24.506 +3055 4 10.0967 27.7204 2.22826 -30.9372 -12.069 25.0324 +3056 4 10.8782 28.8813 1.73209 2.10338 1.16742 -2.23752 +3057 6 47.025 23.1272 13.2603 -26.8307 -11.5375 0.419605 +3058 4 47.6563 23.6094 12.7175 1.22463 1.60122 -3.88323 +3059 4 46.2701 22.846 12.6737 25.4538 5.98786 18.4886 +3060 6 34.5769 28.3999 10.6617 -26.3731 9.09486 -11.6064 +3061 4 34.5145 27.7223 11.3448 13.7244 -2.44185 1.37306 +3062 4 35.5023 28.5375 10.4336 6.33869 -4.76798 1.2135 +3063 6 3.33738 17.579 14.2816 -4.12164 13.1786 -2.02309 +3064 4 3.51487 16.7052 14.5979 -0.480238 -24.8864 6.17379 +3065 4 3.96197 18.0965 14.8055 -3.35437 6.17503 -1.46632 +3066 6 27.7248 11.5976 7.52038 4.0705 34.1711 4.34085 +3067 4 27.7194 12.5939 7.6487 2.26317 -33.1326 -4.66749 +3068 4 27.2616 11.2314 8.28138 -1.22149 -2.70865 2.4378 +3069 6 41.4317 28.339 9.02961 12.1835 18.6619 -21.5911 +3070 4 40.932 28.9387 9.57928 -8.65956 3.59764 13.3257 +3071 4 41.6711 28.9179 8.26221 -0.754142 -18.9314 12.3863 +3072 6 42.0732 4.78493 8.18399 0.592074 10.501 -23.0953 +3073 4 42.2656 5.73441 7.90258 -4.03181 -32.5079 3.94615 +3074 4 41.9391 4.19656 7.39311 5.50228 24.8072 19.85 +3075 6 28.4553 8.6408 40.3288 -1.1592 2.81238 -0.593175 +3076 4 27.8014 8.47839 41.05 3.29603 2.13238 -25.5829 +3077 4 28.0374 8.68456 39.4248 -2.58083 -3.24862 30.0681 +3078 6 0.723272 18.248 15.2854 4.61761 3.31073 11.0333 +3079 4 1.58056 18.1517 14.8782 17.0637 -0.561901 -5.4503 +3080 4 0.169553 17.7112 14.727 -13.9143 -7.94922 -7.42873 +3081 6 7.11829 16.2161 40.455 0.573222 -5.60735 -16.9123 +3082 4 7.21814 15.2583 40.7035 1.10072 25.2259 14.7352 +3083 4 7.17549 16.8833 41.1741 1.82325 -21.1089 2.38217 +3084 6 41.0856 8.6232 20.9154 1.44565 10.3804 -0.748136 +3085 4 40.3857 8.53297 20.2693 -12.0873 -13.8416 -3.91841 +3086 4 41.3541 9.53003 20.731 8.87844 6.62655 8.68036 +3087 6 31.7065 7.41805 37.5384 1.8504 0.880847 10.656 +3088 4 31.4927 7.12037 36.644 -5.569 -4.06437 0.235955 +3089 4 30.9766 7.14703 38.1182 6.88034 1.43502 -8.9471 +3090 6 40.7175 11.6353 25.4105 -5.83472 20.1078 -6.29096 +3091 4 40.8441 12.5768 25.6218 -9.59803 -8.51017 -7.38463 +3092 4 41.5254 11.2592 25.7328 13.3582 -17.7026 5.353 +3093 6 29.8893 30.1615 6.66958 6.45784 -4.04896 -4.41327 +3094 4 30.5285 30.6751 6.15191 0.92206 -5.81994 -1.29615 +3095 4 30.2313 29.249 6.64761 -0.535397 8.70224 -1.24193 +3096 6 40.83 24.591 5.67679 17.1105 23.9162 -4.99229 +3097 4 41.4401 25.3556 5.89599 -18.0089 -21.1831 -4.73113 +3098 4 40.1352 24.5742 6.32932 -4.29697 2.2625 8.62223 +3099 6 34.3954 9.09122 20.4203 -0.702674 2.95809 7.47625 +3100 4 33.5897 9.50113 20.7506 -0.63314 5.38769 7.97821 +3101 4 34.107 8.76785 19.5728 -0.194313 -9.82044 -16.4611 +3102 6 18.2164 33.5433 26.5438 32.3972 -29.6611 -30.5808 +3103 4 19.1929 33.4142 26.4527 -23.3283 -2.37285 -6.48837 +3104 4 18.1915 34.0681 27.3044 -13.0981 29.1765 42.7321 +3105 6 28.9207 17.4075 26.7926 -1.66434 -4.11711 9.90999 +3106 4 28.2497 17.0259 26.21 0.151798 0.605301 -3.15085 +3107 4 28.4243 17.7127 27.5796 8.50802 -3.38176 -8.48604 +3108 6 50.4389 35.5612 18.195 -0.220837 -24.3132 -9.08897 +3109 4 50.4331 35.2145 17.2813 -0.853004 14.3463 8.17747 +3110 4 50.3692 34.7248 18.6968 -4.07606 17.1918 3.62275 +3111 6 2.99582 21.5586 31.4575 0.708202 -18.646 -28.6731 +3112 4 3.24926 22.2892 30.8424 -5.67023 -11.8068 12.1364 +3113 4 2.8516 20.7624 30.8616 4.12476 24.3831 20.6408 +3114 6 36.1857 18.7483 8.60511 9.96184 26.1081 -2.68835 +3115 4 36.1356 17.8778 8.93402 3.95956 -36.7917 21.724 +3116 4 35.6171 18.7388 7.85438 -14.2398 9.24248 -24.4438 +3117 6 20.2742 6.47995 33.7286 -0.427153 4.78104 -4.08195 +3118 4 19.8935 6.35632 34.6244 -2.14212 -11.6635 -12.611 +3119 4 20.0876 5.70362 33.1559 -1.45185 1.76636 16.8362 +3120 6 13.9952 30.5211 6.65468 -0.834568 0.374695 7.89925 +3121 4 14.6781 31.0539 7.1149 -10.4447 -7.07426 -7.17019 +3122 4 13.1432 30.7212 7.07951 7.79461 1.02333 -2.73826 +3123 6 36.2732 16.4484 35.7639 18.345 14.0335 0.961522 +3124 4 37.2268 16.2475 35.9495 -24.6333 8.21497 -3.5549 +3125 4 36.1837 17.4253 35.5797 7.74798 -29.1845 4.36862 +3126 6 45.8208 37.6575 9.69399 14.3507 -31.8621 -27.6249 +3127 4 45.4608 38.3019 10.268 -8.06385 16.394 26.7739 +3128 4 46.3975 37.0305 10.1733 -1.81999 10.6315 0.898341 +3129 6 47.4165 17.984 27.6369 4.10759 -46.3966 -5.45297 +3130 4 47.5682 17.4629 26.7823 -7.01073 17.4072 30.8444 +3131 4 47.4562 17.3293 28.4007 0.542452 20.9274 -25.5144 +3132 6 25.9608 18.2932 0.952258 -4.39486 21.5955 18.9376 +3133 4 26.1989 18.9101 1.66086 12.5057 -8.35286 -7.15646 +3134 4 25.0082 18.3237 1.04468 -12.1408 -13.2893 -13.6751 +3135 6 27.3648 22.4066 4.28268 2.26175 -24.9034 0.419816 +3136 4 27.3706 23.3409 4.46802 1.80952 16.8807 -5.51915 +3137 4 27.3027 22.2785 3.32806 -2.77408 5.10873 4.5687 +3138 6 3.39125 3.84856 27.607 3.69966 -10.1033 0.490887 +3139 4 4.0137 4.55908 27.5406 6.78149 24.6072 0.911673 +3140 4 3.97847 3.09168 27.5281 -8.4044 -12.3732 0.103181 +3141 6 45.3633 27.6554 28.8452 2.12727 -1.25659 10.7713 +3142 4 44.5282 27.2015 28.6866 -4.83999 -4.58212 3.48715 +3143 4 45.3811 28.2979 28.14 4.63148 6.41932 -6.37453 +3144 6 28.4005 32.3772 16.2203 23.7034 -3.75626 0.763822 +3145 4 29.2297 32.2225 15.6968 -18.0553 4.16843 14.9752 +3146 4 28.6795 32.6874 17.1033 -0.325788 -1.29005 -11.6373 +3147 6 9.90477 33.835 13.0292 3.70295 -3.7397 30.9684 +3148 4 9.58558 33.3049 13.7992 6.56164 12.5415 -12.6178 +3149 4 9.32425 33.6546 12.2978 -12.2649 -3.83445 -16.8068 +3150 6 38.3301 26.6316 14.917 8.16845 -9.374 -1.40965 +3151 4 38.7482 25.7736 15.154 -10.3234 14.7528 -2.05039 +3152 4 37.3847 26.6122 15.1206 3.66029 -5.29 2.35016 +3153 6 31.3553 16.3729 4.24558 -11.5598 -13.3523 13.2112 +3154 4 30.5395 15.8971 4.54084 13.4071 7.11555 -7.19651 +3155 4 31.205 16.607 3.32285 -2.62497 2.93757 -4.30077 +3156 6 6.17611 3.41063 6.5613 17.7272 3.64487 37.5473 +3157 4 6.46982 3.08663 7.46094 -9.0795 17.2981 -27.883 +3158 4 6.02642 2.6045 6.08389 -2.81663 -13.5692 -12.3872 +3159 6 42.5919 12.9938 5.62253 0.302259 -11.3067 -0.460125 +3160 4 42.3001 13.8766 5.84478 4.87778 6.39543 1.2284 +3161 4 43.5084 12.9049 5.92305 -2.35353 0.46184 -1.33783 +3162 6 41.0467 31.3953 33.7949 3.79599 37.3117 5.16998 +3163 4 40.7289 31.3961 34.7173 5.05156 -5.30154 -15.2916 +3164 4 41.2174 32.3636 33.5809 -4.47671 -37.1445 4.47908 +3165 6 52.8595 12.0576 26.2617 4.7779 -12.5882 -49.4794 +3166 4 52.3971 12.713 26.7564 -13.8804 18.303 15.9364 +3167 4 52.6839 12.2865 25.2977 8.87889 -9.64762 29.5111 +3168 6 39.2197 4.29237 29.0569 11.235 6.95972 3.08537 +3169 4 38.4782 4.84799 29.3396 4.36118 -6.50894 -4.0878 +3170 4 39.9967 4.59393 29.5615 -4.77927 -7.36273 -4.89832 +3171 6 3.64414 27.0065 11.2815 -12.9441 10.9516 -6.43872 +3172 4 4.59106 26.8908 11.2849 14.3058 -9.72403 4.26042 +3173 4 3.53535 27.8319 10.7781 -8.82957 -2.80904 -0.131447 +3174 6 41.5421 29.6442 25.2671 -5.6293 3.19366 2.66863 +3175 4 41.8684 29.6903 24.3723 12.1179 -3.11764 -10.4285 +3176 4 40.7194 30.1326 25.2057 -6.30215 2.63585 1.74894 +3177 6 50.468 27.487 30.6705 -3.05594 -10.4468 2.57161 +3178 4 50.076 27.1594 31.5009 0.806547 4.01213 -5.24181 +3179 4 49.8217 28.0451 30.2184 -2.62753 1.96724 1.87939 +3180 6 32.7902 33.6258 41.7496 -4.87138 -4.97834 -25.0012 +3181 4 33.1641 32.7497 41.8541 3.47816 -11.5824 1.65798 +3182 4 32.8969 34.0586 0.665858 3.16614 12.7166 21.4132 +3183 6 5.9796 9.64598 7.93234 5.57207 13.1841 -10.7861 +3184 4 5.80592 9.95912 8.82583 -0.986272 -0.521215 4.5825 +3185 4 6.43021 10.3852 7.47125 -1.05258 -10.6241 3.31462 +3186 6 52.774 25.3768 27.6816 12.7732 -3.18466 28.0173 +3187 4 52.93 26.2779 28.0237 -8.60677 -10.695 -13.1321 +3188 4 53.2011 24.8527 28.4031 -8.37753 -2.27765 -26.5487 +3189 6 18.6947 23.2095 14.4724 -28.0966 8.43578 15.8218 +3190 4 18.5587 24.1605 14.7523 20.6562 -24.296 -13.1918 +3191 4 19.5669 23.0215 14.1303 11.4888 10.4676 -1.8787 +3192 6 31.2862 9.0706 13.0896 18.8649 -43.5027 -8.26415 +3193 4 31.2854 8.18164 13.5153 -0.98006 14.2242 -7.24428 +3194 4 30.8139 9.64196 13.6614 -21.2648 23.3567 24.384 +3195 6 52.8349 16.8368 29.9626 -1.04236 -5.83632 -3.7224 +3196 4 53.1314 16.3317 29.1809 4.11254 10.2245 6.81583 +3197 4 53.5336 17.4658 30.2088 5.59995 -2.32318 -6.64835 +3198 6 13.48 30.6403 11.9185 -26.7 12.8254 18.6299 +3199 4 12.8874 31.2649 12.4086 6.11749 -21.3055 -11.69 +3200 4 14.2712 31.1662 11.9231 18.3999 3.72963 -5.07782 +3201 6 24.4118 24.6653 11.1776 -11.0488 -38.9105 0.0232616 +3202 4 25.2327 25.0345 11.4834 15.6111 8.28781 8.86477 +3203 4 24.5324 23.6736 11.237 -9.01076 27.817 -2.51724 +3204 6 11.1207 26.7925 5.93063 -6.41259 2.09364 -8.23675 +3205 4 11.5241 26.98 6.79711 -3.12879 8.72791 -6.17468 +3206 4 10.8719 27.6544 5.50988 6.7003 -18.2386 15.7162 +3207 6 12.0069 32.3194 4.56559 -6.93674 1.89769 -53.2748 +3208 4 11.7104 31.8608 3.68045 16.1117 25.2499 46.2442 +3209 4 12.3686 33.2222 4.3326 -9.20365 -26.1492 2.14142 +3210 6 6.43611 5.48582 30.4705 10.9412 7.27018 -5.81208 +3211 4 6.8324 6.31983 30.1884 15.302 -0.761667 0.276275 +3212 4 5.5204 5.70213 30.4126 -22.6187 -2.98333 3.5448 +3213 6 38.1723 39.6045 29.3805 -11.1368 -0.968084 -7.99101 +3214 4 37.5332 40.3179 29.1036 12.1085 -24.1545 -0.917311 +3215 4 37.9804 38.7063 28.9788 -2.28765 36.4506 5.30967 +3216 6 52.5924 19.3736 5.41149 4.12965 0.0949992 -5.17576 +3217 4 52.3027 20.2712 5.07121 22.7239 -28.0308 -2.84369 +3218 4 53.4989 19.0543 5.10701 -28.7609 25.7225 2.66162 +3219 6 18.3561 9.81057 21.0683 -18.476 -24.6523 15.6829 +3220 4 17.6378 9.45854 20.4828 20.1245 14.4878 5.80252 +3221 4 19.033 10.2869 20.5982 6.82627 10.6552 -20.9713 +3222 6 14.5094 41.1238 15.0395 5.73538 -4.06503 -13.1796 +3223 4 15.2839 41.068 15.6075 4.55031 0.900939 7.74817 +3224 4 13.875 41.6599 15.5263 0.0235554 2.15182 4.98288 +3225 6 36.0027 23.903 26.7597 7.48895 21.6763 -35.676 +3226 4 35.8975 23.6043 27.6465 2.36908 -17.7227 17.2904 +3227 4 36.3267 23.2124 26.1374 -7.97178 4.49324 27.7844 +3228 6 35.6359 10.4157 26.2529 -13.2839 -25.1837 23.1485 +3229 4 35.969 10.5098 25.3716 5.3977 0.436992 -21.1808 +3230 4 35.4229 9.45302 26.3798 5.18698 20.1527 -7.56493 +3231 6 45.3037 24.2791 20.2723 9.06075 11.2998 -13.4968 +3232 4 45.4523 24.978 19.6109 10.2075 -1.49386 4.95329 +3233 4 44.5125 23.8555 19.9662 -13.3892 -9.58217 -2.04663 +3234 6 15.8107 39.0453 24.2393 9.7405 19.086 8.48056 +3235 4 15.3407 39.8143 24.6455 3.07287 -17.6695 -6.90152 +3236 4 16.7434 39.3626 24.1878 -22.1708 -8.11019 0.25747 +3237 6 4.61074 25.9041 16.8066 4.47487 12.325 4.32837 +3238 4 5.33363 26.3313 17.2996 -1.16871 -8.95741 -3.63592 +3239 4 3.89121 26.5439 16.91 5.27726 -3.71411 -3.28281 +3240 6 33.4791 9.99232 32.5716 -36.5508 -4.76722 -31.2046 +3241 4 34.3147 10.2419 32.89 39.2476 10.968 21.6954 +3242 4 33.0188 9.57531 33.3002 0.324125 -5.12222 10.2577 +3243 6 22.9388 37.5185 1.51191 -4.27166 -24.2064 8.31852 +3244 4 23.0334 38.2273 2.154 1.20614 3.86272 6.71724 +3245 4 22.69 36.6978 2.02191 6.96614 23.4315 -10.5782 +3246 6 39.1324 20.5485 25.4772 25.265 -11.778 19.9951 +3247 4 39.2103 21.4279 25.1215 -1.526 12.0473 -3.88318 +3248 4 39.8813 20.4818 26.1301 -17.748 -0.0581828 -14.4699 +3249 6 25.0622 25.0762 37.6014 21.4558 5.76047 -13.7935 +3250 4 26.0349 25.2337 37.6294 -19.4467 -8.38624 -4.14531 +3251 4 24.8891 24.8197 38.5048 -7.65564 -1.94532 12.2316 +3252 6 12.209 35.7591 11.4203 -9.12536 1.25056 -5.53999 +3253 4 11.4995 36.2015 10.8899 19.2305 -11.6187 8.3526 +3254 4 12.8486 35.4161 10.7797 -5.71729 7.89629 -2.43108 +3255 6 42.046 15.7235 20.1276 29.9467 5.46844 -26.2367 +3256 4 42.5818 15.5034 19.3148 -14.0105 1.75231 17.5608 +3257 4 42.3615 16.6209 20.337 -4.0808 -2.27778 2.90042 +3258 6 53.2021 25.4307 39.5282 4.69599 -13.2561 7.07883 +3259 4 53.78 25.8541 38.905 5.49131 5.5629 -6.42231 +3260 4 52.4802 26.028 39.6966 -10.1139 9.50655 0.821399 +3261 6 53.7967 21.778 1.29815 15.5744 -8.20383 1.43914 +3262 4 54.6378 21.4326 0.944441 -3.84265 -1.46767 8.18122 +3263 4 53.3536 22.1543 0.542634 -13.037 9.31425 -11.6048 +3264 6 1.93111 22.4438 20.1768 4.00387 4.12813 31.1185 +3265 4 1.5939 23.2361 20.6593 2.49828 -13.4199 -15.2591 +3266 4 2.41139 21.9607 20.8911 -6.34657 6.89732 -14.8434 +3267 6 41.1871 16.1847 11.4932 0.836017 42.0531 1.99799 +3268 4 40.9413 15.3195 11.802 -9.8633 -17.6073 7.87469 +3269 4 40.5377 16.8617 11.8588 16.4331 -27.7799 -8.96912 +3270 6 17.194 38.6096 9.61825 4.75854 -2.20459 -16.4638 +3271 4 17.8324 38.6167 10.328 10.0816 -0.610832 12.429 +3272 4 16.3385 38.6013 10.0398 -14.9506 0.593169 11.9887 +3273 6 33.2005 12.9606 38.531 8.50507 10.8774 -15.8661 +3274 4 33.6532 13.8203 38.39 -7.98235 -13.7359 5.26797 +3275 4 33.1331 12.8007 39.479 5.11874 5.24255 -4.23095 +3276 6 24.7171 21.675 39.9778 2.8762 -23.2501 -10.2076 +3277 4 24.5558 21.597 39.0096 0.45736 0.189324 11.8412 +3278 4 25.3262 20.9394 40.2143 -5.83632 9.86919 -3.30671 +3279 6 13.5803 15.5602 27.3532 26.1047 30.3564 11.1382 +3280 4 13.1676 16.145 28.014 -3.26959 -8.19558 -5.9347 +3281 4 12.973 14.8589 27.1951 -20.4184 -17.1677 1.43072 +3282 6 24.68 18.7128 9.26691 14.3839 36.3501 26.0009 +3283 4 25.3598 19.2552 8.82532 -5.31062 -15.6251 -9.27674 +3284 4 24.5166 19.2286 10.0937 -4.12977 -20.8661 -14.1648 +3285 6 10.971 8.2031 0.0820528 -5.05885 27.6393 52.7366 +3286 4 10.426 8.82187 0.676738 20.6953 -23.692 -21.2054 +3287 4 11.8511 8.19112 0.51746 -10.8092 -0.715691 -8.01276 +3288 6 15.7168 31.9426 31.3882 -16.0589 -14.8784 11.374 +3289 4 14.8784 32.0139 30.9212 -5.19427 4.39929 -5.1125 +3290 4 16.2361 32.7208 31.1626 4.51908 -4.85975 -1.07492 +3291 6 20.3853 39.1678 21.6201 3.96912 1.70678 -2.15463 +3292 4 19.8408 38.4031 21.9136 18.3946 15.2484 5.21077 +3293 4 21.1259 39.3411 22.2478 -18.5683 -14.4588 -3.61544 +3294 6 38.8575 19.5345 7.60357 -3.22682 7.2187 -10.7103 +3295 4 37.9955 19.1157 7.58645 -3.56529 1.50397 -1.646 +3296 4 39.2183 19.2349 8.43232 7.58358 -7.76078 7.45775 +3297 6 41.3566 29.7161 21.1634 -18.4754 -13.1658 17.2704 +3298 4 41.7904 29.7702 20.3348 3.95998 3.00501 -30.3792 +3299 4 42.0386 30.0045 21.7486 9.4821 7.67994 22.7786 +3300 6 50.7055 33.8359 22.0677 10.0235 -14.5617 12.8511 +3301 4 51.0634 32.983 22.4061 -4.7136 19.0099 -8.42991 +3302 4 50.4062 33.6539 21.1646 0.0172424 0.211956 1.78818 +3303 6 18.1576 11.1602 14.3564 -14.1594 -3.53412 4.86119 +3304 4 18.0624 11.3441 15.3149 3.69196 -2.83217 -14.991 +3305 4 19.1071 11.0831 14.1997 2.21718 -0.861887 0.62752 +3306 6 48.509 14.2737 15.2536 -33.8512 -15.7039 -13.3543 +3307 4 49.4102 14.4821 15.4142 31.3042 4.03673 3.1002 +3308 4 48.4635 13.5769 14.5611 0.497508 10.2707 10.4073 +3309 6 32.9892 15.7452 8.24788 15.5762 1.59093 3.47394 +3310 4 33.8184 15.532 7.78513 -5.99942 0.288096 4.45585 +3311 4 33.1922 15.7362 9.20789 -3.05234 -0.622843 -13.6288 +3312 6 42.9176 4.85532 18.7629 14.1748 1.41964 3.40057 +3313 4 42.9882 5.82921 18.9229 4.77982 -22.1758 1.39114 +3314 4 43.8043 4.45344 18.9624 -18.3785 17.0247 -7.93082 +3315 6 10.5031 23.7237 33.4382 -0.874073 19.9298 2.74355 +3316 4 10.5548 24.717 33.3795 7.7257 -28.8706 -7.54496 +3317 4 11.1379 23.281 32.8547 0.735263 11.3428 1.89897 +3318 6 1.13216 20.0583 11.2836 18.374 17.5884 12.1148 +3319 4 0.491024 19.3349 11.1994 -2.17247 3.20995 10.4498 +3320 4 1.13554 20.5377 12.169 -13.4236 -25.5013 -29.3002 +3321 6 1.52072 39.5358 14.3069 -1.86369 -19.4721 11.7014 +3322 4 0.846705 40.1803 14.5938 4.14733 -5.95668 -5.60613 +3323 4 1.29368 38.6598 14.724 6.32152 28.9753 -9.07681 +3324 6 8.31775 21.6111 14.1387 -15.017 -6.93379 31.3726 +3325 4 8.13664 21.1659 15.0266 4.22851 15.111 -30.7591 +3326 4 7.52757 21.5034 13.5919 -1.9589 1.09648 1.01763 +3327 6 7.16491 13.3069 38.2405 -3.91014 1.61314 -29.5843 +3328 4 6.63698 13.0539 37.4502 4.01765 -4.94514 23.7112 +3329 4 7.51249 14.1719 37.966 2.17516 -8.38294 10.659 +3330 6 46.6268 1.62726 18.6981 -5.20766 -2.9114 16.5849 +3331 4 47.5711 1.68468 18.9367 -9.38594 -0.162468 5.90612 +3332 4 46.1191 1.48652 19.5414 20.1897 3.23395 -16.531 +3333 6 4.07867 8.38347 14.797 30.0262 18.9917 2.43531 +3334 4 3.34187 8.3175 15.3794 -25.1937 -7.21885 10.0707 +3335 4 3.92422 7.81173 14.052 -7.87119 -13.0009 -15.9092 +3336 6 47.5843 36.535 17.848 27.4213 12.0237 5.93301 +3337 4 47.2301 35.69 17.6416 -25.9655 -28.1947 -7.00186 +3338 4 48.5203 36.321 17.8356 11.6458 7.4707 2.49139 +3339 6 48.7172 32.6081 3.62434 16.9155 19.6851 -27.3563 +3340 4 49.4676 32.1613 3.18145 -8.8052 -0.0369675 17.0972 +3341 4 48.3534 32.1141 4.33579 -5.12692 -24.8974 22.5299 +3342 6 26.8624 34.4063 15.194 -5.61502 8.38998 -0.355377 +3343 4 27.128 33.6719 15.7603 3.91671 -4.37186 -8.54489 +3344 4 27.3784 34.3384 14.3661 -3.09932 -5.4603 13.6569 +3345 6 9.98983 27.3411 13.3236 -5.30345 -60.6937 -19.0037 +3346 4 9.94192 28.2179 13.0053 -1.51785 37.2293 -13.4128 +3347 4 9.87191 26.7487 12.5139 4.66007 24.2176 27.9858 +3348 6 2.39898 26.8872 37.357 1.59401 -7.29113 19.9813 +3349 4 2.39832 26.7504 38.3162 -5.28205 -0.510768 -0.23331 +3350 4 3.33711 26.9514 37.1904 14.8183 3.44774 -11.9786 +3351 6 33.3368 17.2756 36.8005 -23.2882 7.84328 1.94786 +3352 4 32.371 17.4043 36.8526 5.24602 0.476467 11.7287 +3353 4 33.4423 17.1515 35.8622 12.5187 -3.29866 -15.2334 +3354 6 10.6624 18.8035 9.30575 -3.98781 15.2275 -14.7508 +3355 4 10.7339 18.764 8.32616 -2.59554 -5.92059 15.2764 +3356 4 10.8972 19.732 9.49452 -1.55193 -6.4517 3.37647 +3357 6 8.57833 27.4047 3.14019 -5.09403 -6.13324 -2.85576 +3358 4 8.57126 27.6547 4.08504 -2.7611 -8.03155 -6.83353 +3359 4 8.4622 26.4231 3.09919 3.19624 23.0742 12.9307 +3360 6 40.6073 33.9264 14.3399 -6.85038 20.2562 -23.9123 +3361 4 40.863 33.245 14.948 0.807967 -8.16399 15.1571 +3362 4 40.0779 34.5716 14.8204 -0.495244 -4.69725 4.10141 +3363 6 53.9925 16.7992 13.6308 6.31935 -7.9338 28.1888 +3364 4 54.0997 17.1551 12.7528 -11.031 14.1585 -18.9596 +3365 4 53.1709 17.0486 14.0912 -3.14305 7.59696 -13.573 +3366 6 39.1497 38.4912 7.40608 -39.1223 4.05884 30.5073 +3367 4 38.8859 38.5922 6.48797 -2.00378 4.08479 -3.77896 +3368 4 38.3062 38.5986 7.97667 35.5804 -2.74434 -28.8566 +3369 6 42.2129 33.6808 29.0138 -24.1371 3.42921 -11.8129 +3370 4 42.1057 34.6378 28.7577 -2.98627 -25.8941 0.854821 +3371 4 41.3475 33.1819 28.8496 28.8118 27.0492 8.45917 +3372 6 2.85866 0.0629173 20.1315 -20.2536 1.52979 -19.4947 +3373 4 2.75203 0.421025 19.2221 8.85994 -2.20895 9.93397 +3374 4 1.96017 41.6124 20.299 15.6791 2.4666 6.01858 +3375 6 24.986 26.9373 24.4454 -5.13687 18.0728 7.96565 +3376 4 25.2851 26.0172 24.3926 4.88984 -3.86206 4.04103 +3377 4 25.2923 27.4081 25.2509 0.579281 -17.4573 -11.648 +3378 6 13.6179 33.9875 7.01366 -9.87556 12.4155 -39.0476 +3379 4 14.4287 33.6264 6.65472 5.99816 -4.92128 6.68342 +3380 4 13.2096 34.3429 6.17379 4.4552 -5.00021 31.0775 +3381 6 17.6494 31.8378 3.38868 3.47258 32.8259 -24.0658 +3382 4 17.3179 32.0585 2.49435 6.00696 -1.44586 18.975 +3383 4 17.3532 30.9566 3.5196 -11.0767 -31.773 11.9025 +3384 6 31.1111 29.8483 35.9167 13.6376 7.61418 -14.6842 +3385 4 30.4141 29.611 36.5018 -19.519 -6.65958 16.6428 +3386 4 31.8988 29.4329 36.2727 4.98993 0.410401 2.8928 +3387 6 31.4643 1.69164 1.93808 20.5111 47.6543 28.2436 +3388 4 30.8038 1.05919 1.86135 -35.916 -50.7273 -13.0106 +3389 4 30.9957 2.32106 2.5233 13.9145 -2.66096 -10.7861 +3390 6 13.7147 9.36591 12.3063 -10.8769 -31.3803 3.40225 +3391 4 14.006 10.2311 12.0687 5.19854 25.7457 4.3425 +3392 4 13.2135 9.34561 13.1466 7.78847 9.513 -6.56361 +3393 6 15.2882 15.1512 12.1315 -28.7349 -8.10496 1.75886 +3394 4 14.285 15.1274 12.2085 32.3197 -4.02875 -3.81405 +3395 4 15.5527 14.5676 11.4001 -6.69875 1.91641 1.76342 +3396 6 44.9132 30.4441 13.088 -39.1187 -0.31911 18.6923 +3397 4 45.3561 30.6438 13.8967 -2.95974 2.37903 28.1101 +3398 4 45.6316 30.4633 12.5179 38.3165 -3.24606 -51.9295 +3399 6 35.1465 37.623 24.8576 -14.1582 -15.7359 28.7413 +3400 4 34.5779 38.3725 25.1706 10.6028 -16.3472 -5.82963 +3401 4 34.9593 36.856 25.4995 5.71155 29.9045 -22.7235 +3402 6 43.8948 19.2936 12.9987 -2.30513 -18.2146 13.0469 +3403 4 43.787 18.3102 12.9069 2.76315 21.1578 4.09431 +3404 4 44.375 19.4187 13.8444 -6.58761 -4.34429 -6.9628 +3405 6 14.1971 27.3925 16.8971 2.69526 11.3314 -20.1154 +3406 4 13.4533 26.7979 16.9981 -2.42546 -10.6182 5.16389 +3407 4 14.0783 27.734 15.9851 5.1255 -3.8968 13.4589 +3408 6 5.08574 37.4729 15.7377 1.34169 3.72011 38.8669 +3409 4 5.88395 37.4897 16.2981 -4.65405 2.63162 7.63907 +3410 4 5.46406 37.2335 14.9215 11.9791 -13.9554 -41.5179 +3411 6 35.4862 36.9766 33.2333 -36.83 -5.70901 2.9599 +3412 4 36.4114 37.1444 33.1615 28.5824 10.2327 4.96708 +3413 4 35.1164 37.4942 33.9725 5.15458 -1.79752 -2.84758 +3414 6 6.636 31.7097 32.9848 -22.7133 -7.33235 -24.9389 +3415 4 7.22761 30.9741 32.8206 4.14198 -5.34147 5.16294 +3416 4 6.9999 32.2337 33.6789 14.5784 9.31919 13.8511 +3417 6 31.283 20.2175 25.4647 -9.91499 -1.61286 9.73388 +3418 4 30.5344 20.24 26.1037 18.6204 0.149313 -5.83605 +3419 4 30.8734 20.4846 24.6365 -0.167457 4.09649 -2.99843 +3420 6 54.9487 26.0868 7.35258 -28.6285 -0.216784 1.76255 +3421 4 54.2955 26.5615 6.794 6.74078 -5.97369 7.99882 +3422 4 54.4034 25.6757 8.0611 9.89476 6.61779 -10.5703 +3423 6 17.8651 35.1614 24.3791 -20.7499 -4.98646 -29.5673 +3424 4 18.0576 34.6235 25.1649 -8.37985 -1.7243 -11.1178 +3425 4 17.2007 34.681 23.779 26.831 10.1018 28.2803 +3426 6 49.1285 3.31358 19.7417 -8.45795 -3.91869 -17.1851 +3427 4 48.8119 4.11203 20.1653 -3.29153 9.9905 4.05996 +3428 4 49.7807 2.96094 20.3466 4.32541 -4.85853 3.16639 +3429 6 30.2844 35.6035 13.4934 7.2001 -0.317469 -2.452 +3430 4 29.4623 35.659 12.9857 1.71884 -1.71824 2.45729 +3431 4 30.0585 35.4328 14.4204 -4.00669 1.3983 -5.34585 +3432 6 43.3887 25.8808 41.6785 -22.9069 -12.3923 -2.55701 +3433 4 43.9997 25.6768 40.9817 12.0928 0.211006 -14.0269 +3434 4 43.8339 26.4255 0.397834 14.8568 14.8319 19.2759 +3435 6 21.0884 23.1529 6.38678 -1.35916 1.28851 13.8592 +3436 4 21.4 23.8645 6.98768 -5.78702 -12.5756 -9.70729 +3437 4 21.3246 23.4545 5.51028 2.40121 5.3387 -13.5131 +3438 6 54.6143 21.1989 19.0895 1.0726 18.3039 13.0104 +3439 4 0.43531 21.5582 19.5367 -15.0683 -8.68203 -12.1911 +3440 4 53.867 21.7044 19.4937 16.3508 -9.47613 -7.9193 +3441 6 13.877 38.9443 18.7624 -3.57764 -10.5141 -5.7706 +3442 4 13.4493 38.4672 19.4981 1.6116 7.10734 -3.21136 +3443 4 14.0821 39.8514 19.0249 -5.40993 2.00969 6.25434 +3444 6 39.1872 2.73234 39.6824 0.14108 0.727177 -8.14712 +3445 4 38.529 2.27328 40.2354 4.03816 -1.16808 -5.22543 +3446 4 39.0548 2.41866 38.7627 -6.48078 -0.982324 12.2661 +3447 6 43.2185 33.8148 8.84061 -19.4182 46.8926 -2.36482 +3448 4 43.1772 32.9719 9.24022 -1.50187 -35.3898 17.2737 +3449 4 42.5163 34.3616 9.29053 19.0727 -15.0644 -10.6104 +3450 6 23.089 16.6827 12.1027 15.7208 -3.2574 -7.89972 +3451 4 23.4385 16.1911 11.3228 -11.6069 8.24456 13.4993 +3452 4 22.136 16.8018 11.9813 0.424679 -1.38664 -3.29845 +3453 6 40.7855 26.1389 36.3196 -19.9126 19.309 9.87347 +3454 4 40.0986 26.8534 36.2514 19.4153 -21.5003 1.38126 +3455 4 41.1517 26.0031 35.4437 4.25962 0.995192 -8.54639 +3456 6 15.1503 11.6717 19.2973 0.724699 -1.19191 17.6918 +3457 4 15.5299 12.2877 18.6792 5.27756 8.7759 -18.41 +3458 4 15.4868 12.0294 20.1269 -4.65024 -4.08223 3.58338 +3459 6 9.86165 29.8154 31.387 -8.94942 -10.7424 5.06077 +3460 4 10.5846 30.1184 31.9716 0.245343 7.83947 -17.0155 +3461 4 9.856 30.1645 30.4637 12.8302 0.479173 21.4055 +3462 6 2.12473 30.035 25.2763 1.78753 8.3758 2.85176 +3463 4 2.08519 29.2167 25.7943 1.54705 3.16986 -12.4779 +3464 4 2.12365 29.8679 24.3136 0.147535 -6.31004 19.3474 +3465 6 49.0081 10.6471 7.05663 3.22839 15.7191 0.010386 +3466 4 49.8069 10.5015 7.59507 -11.7369 -5.9273 -2.35907 +3467 4 48.4474 9.86293 7.09337 3.15572 -10.0552 5.75386 +3468 6 38.6524 34.4248 32.4903 14.0617 12.8107 -4.97275 +3469 4 38.3124 35.2999 32.7524 2.4491 -7.54743 -1.61947 +3470 4 38.3152 33.7696 33.1015 -5.90625 -1.07654 6.02858 +3471 6 24.2925 24.7077 4.76791 -9.60212 12.423 13.627 +3472 4 24.6592 23.9059 5.14091 6.4374 -12.2494 -4.05598 +3473 4 24.0877 25.2629 5.55261 2.76703 -5.61196 -18.2913 +3474 6 44.0394 23.5955 33.7722 -22.1761 -10.7316 25.8053 +3475 4 43.54 23.0408 33.1405 14.8275 10.6039 0.934173 +3476 4 44.7909 24.0173 33.3845 18.136 8.68259 -21.6513 +3477 6 45.1404 31.9557 26.6336 7.63501 -16.8517 -19.5705 +3478 4 44.7419 32.078 27.4825 -5.98757 6.26965 19.5048 +3479 4 44.9572 31.0195 26.4087 0.928196 13.8489 4.22851 +3480 6 52.067 6.35346 22.8527 -23.4258 -19.9992 -0.226773 +3481 4 51.4359 5.65775 23.1792 22.6487 15.1416 -4.78776 +3482 4 51.473 7.11391 22.7826 5.97124 1.02094 -2.8274 +3483 6 5.11659 17.7141 30.4608 -43.6072 -14.7819 8.36724 +3484 4 5.56343 17.5578 29.6371 20.9412 3.52217 -11.7922 +3485 4 5.63141 18.2128 31.0754 22.7819 13.5036 5.79607 +3486 6 48.537 17.0137 6.52887 28.2349 12.1042 -25.3981 +3487 4 48.2628 16.1023 6.56372 -5.81913 -12.4107 2.5618 +3488 4 49.2494 17.0592 5.82246 -25.6562 2.24824 21.9849 +3489 6 13.808 31.3142 23.4689 -3.64011 -9.68131 26.3432 +3490 4 14.1349 31.2178 24.3617 -12.0329 4.75192 12.2102 +3491 4 14.6149 31.173 23.0226 30.8248 -5.26015 -34.1434 +3492 6 28.4946 33.4369 26.0285 16.4638 25.2333 -6.25798 +3493 4 28.7216 32.7387 25.4298 8.48672 -9.67688 -13.795 +3494 4 27.7897 33.0868 26.5316 -24.4903 -9.494 23.2581 +3495 6 9.0435 22.9594 11.008 21.162 0.605596 1.29652 +3496 4 9.33306 22.7779 10.1087 -4.82127 0.713158 -4.26872 +3497 4 9.8456 22.7632 11.5172 -9.5186 2.48902 2.0044 +3498 6 40.5545 4.06728 26.5809 44.6249 -53.7912 6.90123 +3499 4 40.0988 4.06982 27.4038 -17.0162 4.47424 24.8249 +3500 4 40.1579 4.71783 26.0744 -31.5116 46.4114 -32.7723 +3501 6 17.0554 37.9737 20.9489 23.2001 5.84937 -15.1211 +3502 4 17.8184 37.6206 21.4529 -18.1961 -0.773306 2.14347 +3503 4 16.241 37.9215 21.4323 -8.54619 -6.77157 16.0583 +3504 6 31.9589 6.36634 14.2007 -32.7312 -5.18635 1.31695 +3505 4 31.6173 5.45206 14.3159 2.63352 8.72785 -2.4018 +3506 4 32.9006 6.25378 14.1536 18.2531 -4.45925 -0.605861 +3507 6 29.3682 34.9487 39.6588 1.61784 2.82525 -17.5597 +3508 4 29.3689 34.7576 40.5935 -6.77547 -0.101859 12.4897 +3509 4 28.4273 35.0463 39.4168 8.43037 -3.37269 4.33216 +3510 6 22.5699 2.93494 32.1141 -1.63629 -8.86743 4.25418 +3511 4 23.0898 3.67063 31.7669 1.49018 1.71101 -1.29845 +3512 4 22.818 2.15292 31.5827 -1.92581 11.5593 5.09528 +3513 6 51.7444 19.0899 24.8018 18.5566 14.3159 27.8709 +3514 4 52.1262 19.3991 25.6728 -16.855 -8.06891 -29.5747 +3515 4 52.1578 19.634 24.1129 -3.61196 1.33098 2.20453 +3516 6 32.1137 13.664 24.2226 6.2567 1.72658 -37.8727 +3517 4 32.2307 13.7857 25.1378 6.97488 6.10606 45.7276 +3518 4 31.1794 13.5551 24.0935 -22.8325 -3.39176 -1.92521 +3519 6 9.48788 30.1788 28.8037 -7.90151 -0.480281 -10.0021 +3520 4 9.04214 29.3907 28.4657 0.296662 -4.58444 4.12418 +3521 4 9.71381 30.648 27.9899 1.85323 2.91474 4.33114 +3522 6 31.3027 3.12343 24.087 3.70677 4.08208 -3.18372 +3523 4 30.8363 3.94541 23.9161 -7.21645 -1.79011 2.75115 +3524 4 32.1629 3.26377 23.6687 3.35255 -5.74571 3.4439 +3525 6 2.14326 19.8385 36.4613 43.5578 -10.0216 -16.9659 +3526 4 3.05142 19.7594 36.0352 -31.8637 8.98539 19.2185 +3527 4 1.69253 19.0555 36.1346 -14.6763 0.545221 1.96285 +3528 6 36.957 16.7591 14.0918 2.96563 -13.2358 -6.51153 +3529 4 37.0513 17.1687 14.9682 1.23982 -3.45998 -2.6752 +3530 4 37.3406 15.8552 14.1067 -4.20166 12.9403 2.86695 +3531 6 1.82327 11.1921 6.0808 -0.275886 9.47834 -4.04825 +3532 4 1.66503 10.3513 6.51275 0.636708 -7.94921 -0.277572 +3533 4 1.41092 11.8149 6.68093 -3.53423 6.76721 2.7814 +3534 6 43.1526 36.8455 25.2619 -8.14588 -11.3328 3.19442 +3535 4 42.3648 36.774 24.6888 4.17675 -0.750929 11.0286 +3536 4 43.0263 36.2034 25.9927 3.18182 11.8936 -13.2388 +3537 6 32.1279 5.54767 7.01242 2.49094 2.37791 -5.83138 +3538 4 31.9279 4.68363 7.38152 0.218816 -4.41428 4.71371 +3539 4 31.563 6.18782 7.45455 -6.02642 2.24751 5.27561 +3540 6 15.066 21.4965 41.5173 26.6113 -14.2353 0.879596 +3541 4 14.4098 21.4318 0.299313 -13.8163 5.2854 1.00244 +3542 4 14.7314 21.9782 40.7628 -14.3918 6.6959 -6.38566 +3543 6 37.0263 36.0654 5.67599 -8.66989 11.0394 5.08886 +3544 4 36.7926 36.9074 5.26668 1.42879 3.21556 -9.50708 +3545 4 36.6993 36.1724 6.58455 6.67811 -8.44617 -2.15326 +3546 6 39.6264 22.8802 0.345968 -6.61229 0.0560669 1.87747 +3547 4 39.9979 23.7083 41.9266 1.97423 1.58642 1.0556 +3548 4 39.8106 22.8717 1.30105 -0.716498 -2.72173 1.5866 +3549 6 18.4762 23.1875 5.24196 -3.43754 -16.0644 -0.1002 +3550 4 18.2109 24.0785 4.97873 9.26343 12.8459 2.1419 +3551 4 19.3202 23.1705 5.73113 -5.23082 11.7415 -3.58503 +3552 6 34.4866 26.3931 0.410981 -26.1443 -19.9516 50.1306 +3553 4 33.9706 27.0567 0.94736 13.8106 -10.3269 -20.7381 +3554 4 34.4077 25.5868 1.01915 10.7474 25.1704 -28.4611 +3555 6 28.1474 26.0925 40.6196 -28.5345 -18.6936 36.4955 +3556 4 29.0529 26.0026 40.9247 9.18224 2.32741 -2.79367 +3557 4 27.6107 25.644 41.3519 15.6172 17.8969 -31.6189 +3558 6 41.7482 4.39863 30.2421 -5.41295 4.8086 27.4354 +3559 4 42.5847 3.93131 30.2216 8.80522 -6.59194 -7.61494 +3560 4 41.6924 4.68152 31.1831 -5.94926 -0.146025 -12.4776 +3561 6 4.45598 8.30655 29.1222 20.5127 -16.5965 8.52389 +3562 4 3.66946 8.7156 28.7677 -9.60933 13.4518 -0.978151 +3563 4 4.96147 8.97819 29.6123 -10.8114 0.933443 -7.64816 +3564 6 12.9096 9.61234 32.1411 7.95239 -11.3181 7.67023 +3565 4 12.5174 8.82681 31.7782 -9.40951 -4.97415 -8.25208 +3566 4 13.381 9.26623 32.9076 3.83436 11.6436 3.42456 +3567 6 48.6608 16.2478 1.44826 -41.5847 5.12436 -2.24268 +3568 4 49.5977 16.2655 1.51923 27.6715 2.95254 13.2549 +3569 4 48.2356 16.5221 2.2956 18.9339 -8.30142 -14.6437 +3570 6 26.4307 40.0076 21.1903 -9.81311 41.2665 6.04236 +3571 4 27.1749 40.6498 21.1967 -8.04845 -12.0635 0.822588 +3572 4 26.7755 39.1508 21.0026 13.0624 -20.4442 -2.17563 +3573 6 35.79 4.08177 9.00682 -31.6066 0.334495 -4.41207 +3574 4 35.483 4.74976 8.36033 1.0784 -4.66377 5.72074 +3575 4 35.0087 3.86601 9.59196 22.2264 5.21899 -16.6494 +3576 6 52.6895 3.55332 27.8634 16.2443 -8.90238 -17.7273 +3577 4 53.4861 3.5089 28.4695 -19.2533 -5.0216 -23.8454 +3578 4 52.9436 3.34738 26.8904 -3.28408 11.0051 45.9059 +3579 6 48.3169 26.6974 27.3926 25.9077 -23.6746 5.28014 +3580 4 49.0048 25.9927 27.5456 -25.7263 19.495 -6.18754 +3581 4 48.6886 27.4598 27.8411 -2.12981 11.4596 4.51315 +3582 6 24.5097 4.95686 18.7286 -11.1396 -9.34012 13.2359 +3583 4 24.0942 4.18073 19.1756 8.31772 16.1923 -9.35863 +3584 4 23.9484 5.73893 18.8892 6.66511 -10.1227 -0.689949 +3585 6 24.0567 12.4804 28.7686 -1.83015 0.889486 -1.95598 +3586 4 23.1997 12.8888 28.9043 -2.54864 9.49841 4.61676 +3587 4 23.8244 11.6446 28.3683 7.90245 -6.62953 -5.67748 +3588 6 40.1561 27.7426 40.8073 -21.5317 7.14576 -7.35733 +3589 4 40.4932 26.962 41.2601 -12.917 0.0491148 -0.726507 +3590 4 39.1936 27.5721 40.6401 25.9681 1.33069 1.19471 +3591 6 11.9274 13.5458 26.9496 -4.40765 -1.96337 -6.60028 +3592 4 10.9986 13.6678 27.167 -4.51497 -1.32563 0.190923 +3593 4 12.2404 12.8654 27.5442 6.31176 -11.0874 3.59056 +3594 6 52.1902 29.5387 41.394 18.594 -11.3781 3.59259 +3595 4 51.989 30.3087 0.0068425 -9.85392 15.5397 4.91192 +3596 4 53.1003 29.3208 41.6912 -5.64389 -6.04423 -8.59676 +3597 6 17.4867 19.0227 39.1838 -6.27455 21.666 2.75279 +3598 4 17.488 19.586 40.0024 0.860103 -14.9947 -21.9977 +3599 4 17.2876 19.5951 38.4014 5.36511 -12.0476 21.2649 +3600 6 46.2283 27.6807 33.7144 -6.74129 13.676 11.5468 +3601 4 46.0876 28.3582 33.0447 4.86435 -1.49715 -10.0026 +3602 4 45.6533 27.9743 34.4365 0.457797 -3.70748 6.99028 +3603 6 35.8353 29.5439 5.61992 2.49906 -1.59566 -19.7219 +3604 4 35.6527 29.5233 4.66367 4.90114 -0.621078 3.19465 +3605 4 35.4473 30.3766 5.88547 -3.82587 11.7884 10.6864 +3606 6 47.2822 25.7798 30.1513 -10.5766 8.53329 -17.9568 +3607 4 48.1664 25.813 29.7363 -13.2628 3.84456 1.19765 +3608 4 46.6616 26.387 29.6551 21.0058 -12.1546 6.47151 +3609 6 51.3953 12.3638 20.0228 -1.62023 8.46277 -4.73872 +3610 4 50.7529 12.7462 19.4094 4.65296 3.97806 -1.37635 +3611 4 50.8736 11.6867 20.4477 2.10356 -10.8225 11.04 +3612 6 41.9857 18.3757 28.9464 12.9674 -8.39178 -20.9845 +3613 4 42.6678 18.0249 28.3214 -8.5661 8.58724 12.8041 +3614 4 42.4509 18.9846 29.5329 1.95722 -2.13958 -2.01301 +3615 6 53.5955 6.47736 7.49747 -17.4879 -34.0434 -11.6994 +3616 4 53.215 5.56736 7.34717 12.2612 27.0176 1.32153 +3617 4 53.8473 6.47025 8.42428 8.27981 0.813073 3.28926 +3618 6 9.90701 10.6092 26.7593 2.25524 -7.80823 -0.160956 +3619 4 10.2937 10.2906 27.6083 -8.74192 13.2514 -11.8083 +3620 4 9.6719 11.5504 26.8324 5.3909 -8.28719 7.73453 +3621 6 9.32838 39.4044 29.7661 28.1478 19.087 17.9947 +3622 4 10.1636 39.3682 30.3277 -29.6144 2.71186 -18.0569 +3623 4 8.79772 40.1574 30.1092 9.7156 -13.1012 -9.05156 +3624 6 33.3969 4.77935 0.0338577 7.04977 -8.48101 -1.75146 +3625 4 33.7652 5.5373 41.4968 -3.54645 16.0087 -2.35532 +3626 4 34.1271 4.15493 41.8774 -6.76144 -3.49152 6.70786 +3627 6 35.7118 10.6691 34.2465 30.5451 -20.2214 -10.6481 +3628 4 35.199 10.7815 35.0349 -14.696 6.44481 20.012 +3629 4 36.4515 10.0721 34.5187 -16.7263 14.6249 -6.06398 +3630 6 15.1941 17.3851 19.1797 2.70911 -28.1342 -44 +3631 4 15.4897 16.9339 18.3047 -12.3876 19.7973 41.7399 +3632 4 14.2542 17.5546 19.0074 0.407714 2.19657 2.29796 +3633 6 17.478 37.6645 15.4329 -18.9254 1.45878 17.8737 +3634 4 16.9549 37.8023 16.2867 26.4617 -7.60783 -22.0624 +3635 4 18.4074 37.4659 15.6333 -6.79317 3.25497 7.31584 +3636 6 26.2497 8.20945 21.7084 13.406 8.66037 11.1677 +3637 4 26.4123 8.51714 22.643 -13.4745 -7.28424 -22.9055 +3638 4 25.3027 8.1176 21.5293 -5.49097 3.27453 10.4234 +3639 6 0.34 9.90937 15.4047 -28.932 15.8312 -5.67551 +3640 4 1.21626 9.57115 15.2747 8.47529 -16.8828 -5.88536 +3641 4 54.6903 9.41637 14.8207 22.8064 6.49071 10.4803 +3642 6 13.4564 40.6532 9.29599 -22.1307 -5.15585 -0.326819 +3643 4 12.4714 40.4452 9.30279 34.033 7.20134 3.90171 +3644 4 13.9359 39.9749 9.79874 -9.44555 -0.536228 -2.64909 +3645 6 49.5525 25.9167 33.0087 8.30289 -20.978 36.7812 +3646 4 50.1102 25.581 33.7998 -31.2394 16.5759 -41.6702 +3647 4 48.6381 25.5592 33.0807 18.1841 3.33668 -0.378289 +3648 6 37.0921 40.0433 26.4323 -69.9693 32.9093 31.9949 +3649 4 36.1848 39.6472 26.7001 50.2617 0.87061 -16.3943 +3650 4 36.887 40.9984 26.66 23.4133 -30.5831 -16.8038 +3651 6 47.9876 17.8592 12.1588 -8.21233 14.3088 -32.1086 +3652 4 47.5845 18.6288 11.6747 8.44083 -19.6159 16.8154 +3653 4 47.7143 17.8826 13.0665 -7.39134 3.08395 19.3289 +3654 6 27.9663 29.0642 34.1603 1.53587 -18.0299 -1.74725 +3655 4 28.882 28.804 34.3498 -7.37789 1.41773 -2.30399 +3656 4 27.9529 30.0159 34.1809 1.22694 21.8088 1.61581 +3657 6 34.0029 2.78452 13.2168 -24.1529 16.185 8.10865 +3658 4 33.6393 2.32953 13.9926 -4.91269 2.52718 -2.68734 +3659 4 34.7844 2.29731 13.0428 30.2788 -14.7346 -8.06408 +3660 6 28.44 36.053 11.4482 -19.9886 -0.916941 20.5685 +3661 4 28.0041 35.3416 10.9605 0.296796 1.69001 -2.92558 +3662 4 29.0597 36.4216 10.8465 18.9417 8.99323 -20.1084 +3663 6 36.1834 11.364 28.8528 2.80179 -1.8504 -16.6465 +3664 4 35.2026 11.3648 28.9433 17.0081 -1.44193 -10.527 +3665 4 36.4266 11.2403 27.8881 -16.5332 2.0664 24.3605 +3666 6 24.8155 39.488 16.899 1.95651 8.69094 -17.2938 +3667 4 24.2729 40.277 17.0547 2.68209 -2.76325 7.28198 +3668 4 24.7648 39.3887 15.9322 -0.898649 -0.731043 6.96785 +3669 6 49.9432 8.0514 22.8505 -60.8038 -24.1516 -13.0827 +3670 4 49.7668 7.94962 23.7845 10.2147 3.57848 16.1239 +3671 4 49.0378 7.75433 22.5026 41.2245 11.1916 1.13457 +3672 6 52.0935 19.338 10.2277 12.6357 -4.19253 18.0692 +3673 4 51.6063 19.2592 9.39778 1.74616 10.4418 -3.52762 +3674 4 52.4735 20.2434 10.294 -12.5007 -15.5081 -12.5544 +3675 6 24.8386 15.8838 6.12895 -18.3448 14.0073 -0.236232 +3676 4 24.2024 16.3229 6.74681 14.2411 -11.6767 -8.77744 +3677 4 24.4989 16.1625 5.25788 7.11766 -3.93298 6.13727 +3678 6 49.3148 23.6851 8.6303 24.9689 -39.379 16.691 +3679 4 49.2746 22.9584 9.31909 -7.63259 29.9964 -23.4819 +3680 4 48.4638 24.0489 8.3953 -15.5352 0.433996 3.53825 +3681 6 0.208059 10.6481 32.1797 22.1875 -2.28391 4.69689 +3682 4 1.08388 10.2912 32.3483 11.827 -2.86298 -20.6213 +3683 4 54.878 10.581 33.0649 -30.4469 3.74284 18.7822 +3684 6 12.5874 32.9143 13.2407 -35.4131 4.94433 4.95913 +3685 4 11.7345 33.4182 13.1185 22.1299 -14.9844 2.19911 +3686 4 13.2795 33.4792 12.9271 13.1216 10.0242 -5.44208 +3687 6 21.734 32.5657 14.1089 -30.2641 -10.609 17.8788 +3688 4 21.1735 33.3586 14.1938 13.4775 0.171544 -7.80997 +3689 4 21.2373 31.9121 14.6504 18.4585 12.3126 -12.4653 +3690 6 48.1656 34.8484 27.3207 -34.4178 -12.3509 -32.6658 +3691 4 47.5287 35.1179 27.9926 9.598 2.53078 9.45385 +3692 4 47.5616 34.4813 26.6056 29.2581 12.2879 19.461 +3693 6 45.6153 31.2627 36.0943 -37.261 16.4569 21.0579 +3694 4 45.7916 31.8927 35.3904 -0.807743 4.61331 -8.81752 +3695 4 44.8366 31.6277 36.6156 19.759 -7.25665 -17.1647 +3696 6 46.2873 0.296503 14.3622 0.346279 -8.22198 0.0964187 +3697 4 46.2502 1.23933 14.2464 -13.6881 13.1616 4.37405 +3698 4 47.2018 42.0236 14.1712 14.709 -12.2876 -2.23521 +3699 6 14.3299 18.994 40.2006 -30.7379 -32.6603 -9.06287 +3700 4 14.4791 19.2338 39.2972 7.93482 8.11578 -14.4624 +3701 4 14.6855 19.6458 40.7662 17.9566 28.0241 18.1173 +3702 6 14.5596 1.14026 10.2341 26.3279 -2.23148 -9.5451 +3703 4 15.4055 1.22344 9.73443 -17.3894 7.51472 10.761 +3704 4 14.1379 0.381418 9.8097 -7.55267 -3.97863 3.86231 +3705 6 34.4334 40.9199 12.9894 -0.940803 4.29697 -17.7271 +3706 4 34.039 40.5607 12.1545 5.82782 2.6847 22.9711 +3707 4 34.273 40.3011 13.7266 -2.01031 0.481385 -16.696 +3708 6 42.1477 25.6267 33.9881 24.0417 -24.4569 -2.75436 +3709 4 41.6299 25.3559 33.2134 -0.0206438 0.202706 6.41118 +3710 4 42.855 24.9213 34.0976 -22.0628 21.5276 -5.85955 +3711 6 29.1852 22.5895 40.0737 -4.6165 -6.65381 -10.571 +3712 4 28.5947 23.1672 39.581 -0.582997 4.41945 3.85107 +3713 4 29.0675 22.7332 41.0074 -2.93269 3.94269 10.2267 +3714 6 44.8062 18.6252 1.49818 5.72139 3.58279 15.6322 +3715 4 44.9314 18.8801 2.44529 -3.9019 -2.65234 -18.9387 +3716 4 44.0985 19.1782 1.14518 3.29812 2.13948 3.69359 +3717 6 4.47265 10.8135 23.9407 -24.2902 -18.4562 11.3409 +3718 4 5.11906 11.4142 23.6391 22.3407 21.5355 -19.7447 +3719 4 4.51291 10.8829 24.8932 -6.80118 0.381125 6.4492 +3720 6 6.46087 23.0097 28.9948 -0.180046 29.3158 3.74757 +3721 4 7.16357 23.1777 29.6697 -12.977 -15.1924 -17.9731 +3722 4 6.42476 22.0762 28.8013 7.623 -17.0728 6.50296 +3723 6 39.796 25.1427 32.5747 9.70804 -1.04373 -32.2987 +3724 4 39.5377 25.4516 33.4106 -12.9416 11.3784 38.6909 +3725 4 39.6539 25.9218 32.0211 1.09764 -5.16827 -8.54386 +3726 6 40.8629 21.4836 8.86543 0.741147 13.6451 -7.24725 +3727 4 40.6441 21.3431 7.92826 2.29745 -6.5969 8.98303 +3728 4 41.3236 20.7041 9.20266 3.81714 -8.25026 -3.81722 +3729 6 0.635293 1.4289 12.9408 -11.8573 10.3167 -17.0811 +3730 4 54.7874 1.76314 12.6159 9.08744 8.74788 -10.2417 +3731 4 0.270536 0.805051 13.547 10.8795 -21.9384 23.5147 +3732 6 32.6734 29.7199 23.4842 -6.31159 -22.9731 3.95312 +3733 4 32.3164 28.805 23.472 7.37478 14.3791 4.20759 +3734 4 32.5291 29.9779 22.5736 0.738758 10.2783 -10.1223 +3735 6 12.5322 37.1564 20.4866 30.6876 51.3804 29.6269 +3736 4 13.0449 37.1468 21.3313 -10.4644 -1.04639 -16.0138 +3737 4 12.1935 36.3015 20.3752 -17.5174 -49.5479 -6.43685 +3738 6 13.879 14.5208 24.6979 -2.0089 -0.488943 14.0828 +3739 4 13.5126 15.2415 24.1863 -2.86121 7.01781 -5.24136 +3740 4 14.0435 14.8889 25.5812 -0.885703 0.504049 -6.33424 +3741 6 17.5084 27.0547 26.4789 25.7109 3.2743 -38.4356 +3742 4 17.3703 27.9297 26.0618 -4.07905 -12.769 13.7294 +3743 4 18.1097 26.6273 25.8042 -17.4354 5.34049 24.3014 +3744 6 54.4807 9.52867 26.3526 -8.08409 11.5192 21.059 +3745 4 54.0543 10.3952 26.5681 7.59002 -15.9534 -5.94965 +3746 4 54.8701 9.18952 27.1901 -5.85154 7.09102 -14.0848 +3747 6 33.6811 21.5047 24.9231 9.13792 -2.03882 -43.3211 +3748 4 33.6373 21.3676 23.9235 3.71376 4.25849 32.7793 +3749 4 32.846 21.1613 25.2346 -13.4677 -6.75943 10.2286 +3750 6 22.147 35.267 2.89295 -1.50127 3.24452 17.3348 +3751 4 22.2381 34.4 2.47628 0.948748 -2.82555 0.0189077 +3752 4 22.0999 35.1233 3.8735 0.523717 -2.91888 -18.7193 +3753 6 45.3111 5.3951 15.6139 -0.0233827 -18.9082 29.3701 +3754 4 45.1442 5.22798 16.5663 9.63366 2.6406 -14.7931 +3755 4 44.5125 5.84005 15.3428 -8.81534 4.22624 -14.6387 +3756 6 5.67663 7.59044 16.9735 -0.040306 4.08799 -12.5895 +3757 4 5.28026 7.88599 16.128 7.47401 -1.2917 10.5251 +3758 4 6.58383 7.937 17.01 -0.793937 -3.87211 -2.68331 +3759 6 34.58 39.0977 27.2045 1.42769 14.436 -3.31523 +3760 4 34.2907 38.4975 27.863 -0.77861 -26.0942 16.6839 +3761 4 34.0642 39.8725 27.4397 -1.42861 13.6713 -5.6929 +3762 6 32.7657 33.6085 34.293 -22.4583 20.5671 -18.6673 +3763 4 32.1806 34.0441 33.6111 23.9751 -17.2665 15.818 +3764 4 32.4638 34.0082 35.1245 2.30326 -6.42306 -1.86009 +3765 6 30.988 41.2133 32.384 -4.02481 -7.82035 -3.95856 +3766 4 30.2267 41.2202 32.9774 -4.32902 6.50081 -0.328838 +3767 4 31.0509 0.17511 32 -1.2051 10.1503 -2.92525 +3768 6 7.6493 1.59177 27.1464 22.3535 -22.6118 -16.4669 +3769 4 8.41104 1.29664 26.5499 -29.8997 15.2665 16.3611 +3770 4 7.54328 2.53873 27.061 4.65755 9.49162 -4.22239 +3771 6 0.888965 22.101 37.8501 15.4112 -23.8094 -16.9331 +3772 4 1.26739 21.3109 37.3638 -11.0686 24.0488 15.8162 +3773 4 1.18 22.8712 37.3372 -1.61814 -2.27923 2.93708 +3774 6 7.39632 11.121 19.2332 -2.86932 4.41375 3.62624 +3775 4 7.58751 12.0436 19.3904 -7.23274 18.3647 6.41875 +3776 4 8.29083 10.7877 19.1848 5.97481 -12.1861 -3.76707 +3777 6 43.7816 12.5054 37.3126 2.86093 2.78929 -1.28281 +3778 4 43.9727 12.4749 36.3586 -3.06612 0.785718 5.83621 +3779 4 44.6572 12.6706 37.7021 -4.14278 -2.20963 -1.61523 +3780 6 29.0947 33.5132 36.1777 7.61955 17.1376 -26.1106 +3781 4 29.8261 34.0815 35.8667 -13.5031 -6.20718 4.51186 +3782 4 29.4784 33.1216 36.9462 10.9925 -12.9866 20.6523 +3783 6 14.807 4.60084 3.93512 20.0881 9.19657 -13.3363 +3784 4 14.316 4.04064 3.33426 -13.0632 -7.60853 1.79497 +3785 4 15.6236 4.79338 3.42413 -10.111 -0.253003 10.8348 +3786 6 39.0437 6.41097 6.40143 -11.952 4.4329 11.9095 +3787 4 39.4604 7.16771 6.02322 8.12547 27.0605 -0.357881 +3788 4 39.3566 5.75952 5.7919 -0.567413 -21.3616 -5.48613 +3789 6 22.2146 37.9992 40.767 -9.02066 -17.4896 -19.1754 +3790 4 22.494 38.8839 40.5618 6.85259 22.4587 -5.93601 +3791 4 22.4583 37.8811 41.6743 4.99519 -4.33654 23.0463 +3792 6 4.4524 23.286 6.15211 29.8095 -7.21279 -13.1375 +3793 4 3.81791 23.938 6.45512 -14.4589 -6.71938 9.72163 +3794 4 4.31449 22.3781 6.49744 -8.68344 13.1635 4.00749 +3795 6 12.4271 23.7748 9.24631 -1.26755 4.43152 21.3749 +3796 4 11.5607 23.6235 8.88266 -11.7175 -2.77193 -9.11925 +3797 4 12.2509 24.3149 10.0432 11.3809 -1.60307 -13.9136 +3798 6 46.4989 15.2625 16.9679 -12.8481 -2.49131 10.8408 +3799 4 47.085 14.9252 16.2779 8.49272 6.07271 -3.86524 +3800 4 46.8927 16.0486 17.3753 9.61298 -1.72862 -3.23202 +3801 6 34.1182 27.164 19.7815 17.9289 -11.392 6.58771 +3802 4 34.8637 26.5005 19.7508 -17.7467 14.3364 5.12367 +3803 4 34.0077 27.4664 20.702 3.31322 -6.80894 -12.4792 +3804 6 46.9518 13.2225 35.1059 11.5726 -0.299351 34.0182 +3805 4 47.3951 14.0533 34.9197 -1.30218 2.22738 -12.772 +3806 4 46.5273 12.8898 34.3328 -6.46075 0.0352155 -21.0879 +3807 6 50.5846 18.7905 12.5321 0.161349 -2.47544 -10.5355 +3808 4 49.7474 18.3698 12.2516 10.3296 3.30344 0.704295 +3809 4 51.1853 18.7954 11.7538 -11.6392 0.795373 7.80699 +3810 6 32.4849 12.6316 31.9547 13.623 -32.1984 -17.1952 +3811 4 32.7548 11.6805 31.9646 -3.77817 17.5545 -6.43374 +3812 4 32.3724 12.7906 32.8759 -7.39939 11.2146 27.5789 +3813 6 6.21204 19.6856 10.0139 6.84548 18.8235 13.1049 +3814 4 6.54027 20.2383 9.28123 0.761161 -1.37122 2.72757 +3815 4 6.08461 20.3138 10.7689 1.69871 -13.3343 -16.4193 +3816 6 21.5267 21.5372 2.4283 -5.72751 11.2346 -5.82425 +3817 4 21.7624 21.5115 1.48057 4.80944 -6.6677 9.03128 +3818 4 21.9699 20.8013 2.88237 1.68469 2.19074 -10.3234 +3819 6 38.389 23.0803 17.19 -15.8009 11.2489 14.8144 +3820 4 38.843 23.3405 16.3672 7.30113 -17.2523 7.40945 +3821 4 38.5581 22.1678 17.4979 8.57434 6.38113 -15.3203 +3822 6 29.7009 24.9705 22.2505 40.9979 -45.9373 -29.6811 +3823 4 30.2007 24.9541 23.0531 3.51493 7.58579 28.6285 +3824 4 28.9709 25.5198 22.3387 -45.941 40.092 17.1582 +3825 6 30.3026 21.4444 37.7784 -57.0222 17.1687 -23.3742 +3826 4 30.3615 21.3347 36.805 9.38026 -2.23221 21.4717 +3827 4 29.3011 21.6413 37.9016 49.3444 -12.8915 1.59191 +3828 6 11.8723 11.7062 16.3108 -33.4349 -15.0686 -41.1118 +3829 4 11.3207 12.2631 16.8681 -3.98396 2.02201 -1.40695 +3830 4 11.3108 11.5232 15.4705 24.8968 9.48818 41.0096 +3831 6 5.70652 16.9717 10.4705 4.17204 -12.2255 5.26049 +3832 4 4.89872 17.0293 11.0039 1.44556 1.21447 -8.81597 +3833 4 5.85075 17.8293 10.0626 -3.65007 4.58518 2.58079 +3834 6 41.6977 34.1692 35.8837 -2.16171 7.35997 35.3278 +3835 4 41.9434 35.0359 36.2767 -7.39108 -12.3774 -11.2945 +3836 4 41.6554 34.2509 34.9408 0.248654 6.88642 -24.6778 +3837 6 33.755 1.15956 30.1148 26.9661 -5.30311 0.785489 +3838 4 32.8327 1.41064 30.2749 5.35845 -2.81639 19.5818 +3839 4 34.3082 0.981132 30.9387 -30.8845 7.54253 -18.2089 +3840 6 50.3537 18.6141 36.9811 22.0078 18.2711 -1.17075 +3841 4 50.0553 18.9081 37.8421 -3.0234 4.11827 7.26126 +3842 4 49.7241 17.9789 36.6994 -26.7065 -28.1871 -12.5747 +3843 6 24.6713 24.2747 40.2422 -22.5478 13.5437 8.83718 +3844 4 23.7682 24.4281 40.6159 16.469 -5.34198 -8.29501 +3845 4 24.8078 23.3187 40.2616 -1.76472 2.5507 -0.358513 +3846 6 37.3089 22.0315 23.2412 -5.67505 16.6134 8.34505 +3847 4 36.9227 21.8066 24.1113 8.4343 -8.15598 -10.5545 +3848 4 37.8295 21.3076 22.8826 1.63944 -5.88141 4.04288 +3849 6 48.4175 40.505 28.9613 -8.44239 17.3351 -31.8351 +3850 4 48.9168 41.2502 28.5701 -3.67522 -6.90368 3.5913 +3851 4 47.6498 40.4225 28.3398 9.75729 -4.39015 14.633 +3852 6 24.8456 8.73476 16.5822 -4.20971 0.107082 12.7896 +3853 4 25.4166 9.33437 17.0882 0.801486 -3.84637 -6.6671 +3854 4 25.3552 7.93888 16.3774 1.47583 -1.66023 -1.71228 +3855 6 19.2415 22.9983 32.4591 18.0731 -7.21062 -7.32059 +3856 4 18.4972 23.4837 32.0941 -3.55414 -1.2008 3.19393 +3857 4 18.9283 22.447 33.1757 -6.31405 0.951806 3.86493 +3858 6 3.33315 21.6719 22.4471 -31.3651 -15.1442 10.7623 +3859 4 2.72119 22.0562 23.134 20.4737 -7.45649 -18.1084 +3860 4 4.09369 22.238 22.38 14.9219 12.7334 2.89238 +3861 6 10.2287 20.327 12.827 -13.2346 -13.5387 -5.73443 +3862 4 9.59835 20.9044 13.2794 3.30523 -1.6991 -3.3419 +3863 4 9.66163 19.6709 12.3619 8.96671 11.3846 7.22783 +3864 6 9.52445 0.665703 25.3447 51.6699 36.9138 -22.1471 +3865 4 10.407 0.70007 25.8038 -28.3091 -11.588 2.11711 +3866 4 9.73816 1.30323 24.5834 -23.5062 -26.9191 23.3279 +3867 6 10.6629 40.7098 9.64162 -13.7092 -10.0604 -17.7529 +3868 4 10.6663 41.3337 10.3633 -2.25222 9.44489 9.13119 +3869 4 9.9177 40.9644 9.04966 14.1089 -1.91013 12.7496 +3870 6 46.3583 25.2138 32.6818 -7.00173 28.401 24.5039 +3871 4 46.1658 26.0815 33.1748 9.63216 -40.3762 -24.4036 +3872 4 46.6683 25.4845 31.8081 -0.340565 -0.626762 -0.366217 +3873 6 38.9398 3.19835 23.1062 35.7507 -3.98021 4.80576 +3874 4 38.0789 3.42388 22.7807 -21.691 0.0477325 0.592254 +3875 4 38.9606 2.6551 23.9199 -14.9585 3.95725 -7.0779 +3876 6 33.3518 23.6324 36.8776 -10.909 11.1506 22.2396 +3877 4 32.7475 23.7189 37.6717 16.9933 -10.7727 -23.1962 +3878 4 33.5054 24.5617 36.6454 5.48307 -3.56245 -8.14833 +3879 6 51.9403 33.327 25.4307 18.0164 46.0043 -41.5452 +3880 4 51.481 33.1217 26.2288 -14.6019 -1.8433 25.1586 +3881 4 51.8744 34.3335 25.2555 2.07578 -44.1738 12.4077 +3882 6 32.1773 25.016 33.1611 -3.65323 12.5958 -4.40686 +3883 4 32.7417 25.8243 33.1248 -13.2213 -13.5953 2.20315 +3884 4 31.2567 25.3353 32.9959 15.6883 -4.24783 1.324 +3885 6 51.2804 27.7082 39.5058 -12.4055 -13.8576 13.4454 +3886 4 51.6333 27.8214 38.6405 7.56348 -1.28822 -27.9214 +3887 4 51.668 28.4332 39.9759 4.38661 13.1583 16.7532 +3888 6 34.2776 28.325 17.2612 18.5433 -9.6807 0.726105 +3889 4 33.4618 28.7621 17.0499 -21.6526 10.7978 2.5619 +3890 4 34.2928 28.1986 18.2187 -4.64072 -2.98555 4.57564 +3891 6 36.914 8.0422 37.8636 -11.4128 -16.3489 28.1347 +3892 4 37.1972 8.46051 37.0352 12.2245 9.0272 12.2411 +3893 4 37.2151 8.41454 38.7513 -7.64029 -1.69915 -40.4466 +3894 6 34.8876 19.4054 6.12727 15.6033 7.52257 2.15709 +3895 4 34.0531 18.9355 6.15655 -6.74313 -1.04378 -1.75599 +3896 4 34.6977 20.3552 6.00766 0.606543 -4.24654 -1.2187 +3897 6 52.9513 9.46866 7.83406 2.51792 52.5995 -46.1577 +3898 4 52.8182 10.1965 7.1313 21.8169 -33.4663 26.408 +3899 4 52.1097 9.49548 8.25498 -20.9439 -11.3984 23.93 +3900 6 36.2784 5.48477 38.9735 -18.6298 -4.41122 2.56352 +3901 4 36.9459 5.47799 39.6359 15.3203 -14.8264 18.8091 +3902 4 36.5882 6.23606 38.5023 -2.18903 24.2959 -30.3279 +3903 6 10.0091 14.4595 13.4727 4.14065 20.8003 14.1725 +3904 4 10.1735 15.3719 13.8184 -7.35802 -17.2864 -8.75733 +3905 4 9.20522 14.5177 12.9398 -1.57173 0.82324 -0.279823 +3906 6 17.2166 24.3595 39.7866 10.3316 -24.6644 9.74438 +3907 4 16.8461 25.2181 39.6219 -11.8102 15.8188 2.99696 +3908 4 16.9967 24.0978 40.7081 2.51259 6.67153 -9.86646 +3909 6 49.0842 32.5535 7.76087 3.66191 -12.3496 8.85055 +3910 4 48.2705 33.0417 7.89853 -4.87459 2.09702 3.01394 +3911 4 49.5463 32.9698 7.04629 8.35168 7.01386 -14.6239 +3912 6 44.8849 24.3899 5.46806 25.9844 8.68062 13.8603 +3913 4 44.662 24.5947 6.37974 6.74107 7.22813 10.7323 +3914 4 44.0754 24.0079 5.20592 -32.7636 -20.0017 -25.3594 +3915 6 37.3054 29.188 32.8461 11.1431 -5.59449 16.1726 +3916 4 36.8523 29.4202 33.6742 6.83247 1.44061 -4.51415 +3917 4 36.6742 29.3068 32.1579 -22.7291 3.94299 -14.9304 +3918 6 0.907991 24.8221 21.2346 15.0832 19.7352 -4.57067 +3919 4 1.06453 25.2816 20.3717 -1.39622 -8.03116 21.3543 +3920 4 1.45755 25.2897 21.9154 -11.7661 -11.1398 -13.6241 +3921 6 53.0192 2.206 13.0014 -0.818186 11.5483 2.08343 +3922 4 52.7824 1.81345 13.8314 -6.90556 -15.4066 8.50991 +3923 4 53.4537 3.0128 13.31 2.83183 5.68595 -7.528 +3924 6 24.3052 33.9756 13.9324 20.4312 -11.5489 10.0229 +3925 4 23.7773 33.1726 14.1229 5.8111 10.1191 -2.33499 +3926 4 25.2169 33.8698 14.327 -30.0349 3.28274 -10.0023 +3927 6 40.9302 19.2912 0.318024 -15.3988 27.4065 1.86032 +3928 4 41.1581 18.3902 0.297675 9.36546 -44.4479 -0.119704 +3929 4 41.7646 19.7516 0.396104 7.20249 9.57203 1.55489 +3930 6 38.311 32.026 21.5914 -16.5672 24.1097 -12.7773 +3931 4 37.7777 31.3762 21.1012 4.07846 0.69211 1.97712 +3932 4 37.9765 32.9287 21.3171 8.34414 -28.994 10.9395 +3933 6 42.3062 34.9979 16.9676 -25.16 18.3345 5.87282 +3934 4 41.5364 35.0784 17.5803 19.0968 -0.611651 -8.13832 +3935 4 42.7061 34.1505 17.1117 7.13758 -14.417 1.0169 +3936 6 19.559 24.3289 21.9471 -10.3882 -39.985 28.3228 +3937 4 19.0651 23.5074 22.2416 22.0177 25.9498 -5.97634 +3938 4 18.911 24.732 21.3859 -10.0006 10.9377 -12.5795 +3939 6 21.0734 3.08215 14.9508 5.66735 1.93263 4.27485 +3940 4 21.953 3.50152 15.1067 -15.9394 -6.36392 -7.95302 +3941 4 20.9814 2.87634 14.0019 2.73511 2.88399 3.27523 +3942 6 16.4416 12.1461 28.5328 0.855962 3.79198 1.54672 +3943 4 16.9672 12.6551 29.168 -2.37031 -0.949071 -4.41291 +3944 4 15.802 12.7688 28.1665 0.405815 -3.95107 1.98596 +3945 6 29.5641 4.71626 21.7415 17.492 -20.3905 -14.0863 +3946 4 29.717 3.79719 21.4198 0.937107 17.7735 8.56359 +3947 4 28.6765 4.939 21.4721 -9.06619 5.19467 -0.439365 +3948 6 47.4133 12.088 13.4013 -19.6032 -12.6622 16.1152 +3949 4 46.7677 12.2286 12.6843 7.8139 0.82382 7.69043 +3950 4 46.8958 11.6888 14.1608 19.5987 16.3505 -27.3211 +3951 6 26.4348 0.0314913 5.59163 -38.6673 11.9556 1.59378 +3952 4 25.5144 0.513751 5.59151 44.3701 -31.5426 2.21012 +3953 4 26.2832 40.9933 5.84663 -4.6239 23.4679 -5.56234 +3954 6 20.8211 34.8097 41.3598 6.97593 19.5597 16.9804 +3955 4 20.8796 35.753 41.6458 -3.00787 -20.9192 -8.75426 +3956 4 21.5767 34.358 41.784 -4.89338 4.10004 -2.4608 +3957 6 12.6876 17.479 1.38718 -1.79098 16.5747 12.6529 +3958 4 12.721 17.2085 2.3151 1.79447 -6.15344 -4.56661 +3959 4 12.6249 16.7029 0.834077 -0.882684 -12.7315 -6.97767 +3960 6 30.0809 10.1879 8.41184 2.17826 -2.71045 -21.4672 +3961 4 29.3744 10.7602 8.07412 2.70218 -2.7161 1.39802 +3962 4 29.921 10.0821 9.33998 -2.4398 0.0699553 19.6849 +3963 6 36.338 5.45526 23.9203 5.99313 10.0946 16.1749 +3964 4 36.1182 6.35936 23.6236 3.48165 -5.42435 1.21963 +3965 4 37.0503 5.55216 24.5976 -11.7354 -2.45534 -11.6386 +3966 6 34.0137 39.9398 19.5054 17.9066 -9.75089 21.0607 +3967 4 34.5988 39.5452 20.1731 -15.7075 -1.02338 -1.83906 +3968 4 34.6431 40.5289 19.082 -7.6391 9.5881 -14.1485 +3969 6 25.1112 29.0201 17.0007 35.0878 36.529 -22.1514 +3970 4 24.4917 28.3695 17.2244 -30.3786 -36.8419 16.5077 +3971 4 24.8604 29.2867 16.1023 2.15056 -2.21883 6.37313 +3972 6 28.5036 21.3308 6.52422 21.0338 -5.55128 30.7615 +3973 4 28.0688 21.6386 5.71574 5.06238 16.4658 -0.926129 +3974 4 28.989 22.0506 7.05137 -24.5794 -13.751 -30.0602 +3975 6 18.6637 26.1498 0.432001 -8.53447 25.4727 10.2843 +3976 4 18.1393 25.3713 0.533905 -9.92127 -26.6833 -5.54807 +3977 4 18.1707 26.7698 1.00478 10.6071 3.27379 -7.60185 +3978 6 10.9817 29.7047 15.4617 -41.5317 11.7513 13.4553 +3979 4 11.6879 29.3608 14.9846 35.2501 -21.9962 -32.1318 +3980 4 11.3889 29.9926 16.2601 5.02956 8.45945 23.8164 +3981 6 33.4827 3.76017 10.5773 -2.41261 -0.304069 24.838 +3982 4 33.4731 3.39919 11.5182 2.46452 11.5285 -31.0446 +3983 4 33.5847 4.73535 10.6555 -0.240223 -15.9168 2.16837 +3984 6 12.2973 28.805 23.0387 -1.70787 -5.55619 5.61474 +3985 4 12.73 29.6571 22.9381 2.67417 5.94729 -0.690524 +3986 4 11.5024 28.994 23.5653 2.03311 -0.198261 -3.05575 +3987 6 13.0915 10.291 41.0216 -35.9662 5.53295 8.52282 +3988 4 13.8386 10.0408 41.5246 29.6538 -8.48465 17.7322 +3989 4 13.4107 10.5366 40.1733 8.17866 7.18603 -23.992 +3990 6 45.8162 29.981 22.3537 -23.4909 -34.782 -9.94688 +3991 4 46.3605 30.6906 22.6479 19.8522 18.211 11.3118 +3992 4 46.1638 29.1315 22.7274 -3.04842 19.9099 -5.39144 +3993 6 41.5671 12.1372 14.78 12.0724 6.03101 -10.0784 +3994 4 40.8481 12.1001 15.4119 -11.2612 -2.38036 6.73971 +3995 4 41.9114 13.0311 14.8874 5.93112 4.19505 -0.667369 +3996 6 18.1729 7.20363 24.1739 -28.0382 48.7978 3.52623 +3997 4 17.4064 7.85498 24.128 33.406 -18.9268 -1.93395 +3998 4 17.7199 6.38321 24.1568 -14.2968 -40.16 -0.285645 +3999 6 1.47767 28.308 7.57167 -25.5616 27.2209 -25.1393 +4000 4 0.827452 27.622 7.68711 2.49251 -16.9659 6.86802 +4001 4 0.906232 29.0217 7.18328 24.331 -5.18373 6.93061 +4002 6 11.3359 12.3164 24.0718 -23.8013 37.4997 -14.7667 +4003 4 11.6691 13.0224 24.6595 3.51665 -15.1291 3.43827 +4004 4 11.6925 11.4858 24.3227 20.8697 -21.176 20.4973 +4005 6 17.9852 40.4684 24.4198 -2.05389 -13.7174 33.2687 +4006 4 18.291 40.9889 23.6947 8.79563 24.1615 -11.819 +4007 4 17.8495 41.0209 25.2243 7.13458 -7.65509 -20.9696 +4008 6 25.5964 7.43792 34.0141 13.5012 12.0052 -20.5927 +4009 4 25.8913 7.969 33.2287 -3.90825 -14.1502 17.4414 +4010 4 24.6674 7.63663 34.1466 -9.57807 0.741149 3.27376 +4011 6 16.9692 36.3856 7.79034 -41.9934 -28.8773 9.66508 +4012 4 16.1027 35.9203 7.98218 37.4859 8.56847 -14.648 +4013 4 16.8197 37.2026 8.24874 12.7807 20.325 5.07796 +4014 6 12.4125 39.1679 36.8113 4.83627 -30.6012 -9.1357 +4015 4 13.2866 39.4994 36.9682 3.20673 22.8904 8.84646 +4016 4 12.7018 38.3069 36.4569 -23.4958 5.90479 1.90955 +4017 6 23.4443 1.91649 37.7131 1.30421 0.985484 -2.89526 +4018 4 22.7028 1.66545 37.1374 7.60384 11.2995 4.79583 +4019 4 23.7753 2.79308 37.4363 -6.35903 -5.24233 -3.11404 +4020 6 26.6169 34.8556 39.068 -18.8945 24.0174 -16.1573 +4021 4 25.9011 35.0209 39.7003 9.00825 -5.11239 -0.809586 +4022 4 26.448 35.531 38.356 7.64302 -20.2436 14.8851 +4023 6 44.7566 35.572 23.174 8.53117 -4.94531 -21.3447 +4024 4 44.5551 36.3183 23.7275 -7.66893 11.3086 12.1688 +4025 4 44.9082 35.9286 22.2729 -0.906387 -11.1819 10.3159 +4026 6 34.6091 35.4265 26.6991 -7.96701 8.74937 -1.29134 +4027 4 33.7558 35.2865 27.1578 16.0802 3.93421 -4.37465 +4028 4 35.2785 35.5457 27.4013 -9.86041 -2.80018 -4.60569 +4029 6 12.4308 29.8402 9.37325 4.00701 15.5633 13.1387 +4030 4 12.6298 30.2095 10.2592 0.427445 -8.8693 -11.9579 +4031 4 11.9163 30.5385 8.94302 -0.259504 -4.09781 -0.505047 +4032 6 46.4536 41.3715 16.9585 -0.509472 -10.7221 -3.48983 +4033 4 46.3968 0.20327 17.5639 0.209317 7.43894 6.10767 +4034 4 46.3711 41.769 16.0793 0.075994 -2.20044 0.741492 +4035 6 39.1811 31.047 24.0166 -28.3946 14.7902 -31.7872 +4036 4 39.0009 31.2944 23.0615 15.0891 -8.50563 28.3067 +4037 4 38.282 31.1199 24.3765 13.6746 -2.33731 7.34059 +4038 6 40.5375 9.75603 28.9763 9.47615 -22.8392 -16.3574 +4039 4 40.717 8.78834 28.9749 -4.02124 18.0325 0.597023 +4040 4 40.0442 9.94417 29.7674 -4.45736 4.50836 13.2228 +4041 6 33.5752 11.9033 22.735 -22.7947 23.9621 15.9921 +4042 4 33.2963 12.1808 21.8555 7.18969 -8.33444 -8.87292 +4043 4 33.0376 12.5465 23.2695 22.9257 -24.0379 -3.52442 +4044 6 29.0301 38.739 2.44557 13.7604 -11.9544 -20.6568 +4045 4 29.2066 39.6607 2.23242 1.09325 2.62923 1.14408 +4046 4 28.4566 38.7797 3.20164 -8.68487 1.4276 10.4377 +4047 6 51.2789 6.14828 28.303 0.614736 -0.570337 1.8431 +4048 4 51.6973 5.27456 28.1665 -1.53436 11.093 -0.261734 +4049 4 51.6265 6.73477 27.6091 2.17001 -12.1019 4.10374 +4050 6 34.1129 16.6124 14.0322 -32.0491 -20.8609 -4.49638 +4051 4 33.8537 17.5241 13.9801 -4.99199 17.3104 -1.82528 +4052 4 35.0495 16.5739 14.0336 36.3732 5.94549 -0.19423 +4053 6 34.4398 40.0505 7.51971 -1.5967 1.86622 -34.5907 +4054 4 34.4907 40.736 6.82898 6.47702 11.7366 29.0204 +4055 4 34.1466 39.3906 6.89306 -3.09667 -23.6565 15.965 +4056 6 42.5416 22.9885 4.36731 16.709 1.02816 -9.65968 +4057 4 42.6773 23.0677 3.40021 -12.3994 2.37358 9.8727 +4058 4 41.6332 23.2481 4.59133 5.34809 1.54884 -5.45539 +4059 6 1.43335 11.7249 10.5915 17.9648 34.7983 -1.93775 +4060 4 2.18855 11.6351 9.93392 -25.2532 9.63542 18.7746 +4061 4 1.3761 12.7012 10.8984 13.7257 -41.7135 -20.7702 +4062 6 10.0197 17.1509 40.4023 -3.34945 -21.541 12.0793 +4063 4 9.07741 16.8499 40.449 26.596 5.40866 2.75879 +4064 4 10.6028 16.482 40.874 -24.6204 18.7768 -14.392 +4065 6 26.3793 1.16939 23.7984 9.5834 26.112 -20.0106 +4066 4 26.3482 1.63114 22.915 -1.08564 -15.7005 23.7132 +4067 4 26.8817 1.81632 24.3342 -3.35925 -10.5223 -0.68284 +4068 6 4.47487 16.2271 39.0058 33.4959 -10.553 -10.6989 +4069 4 4.63618 15.8937 38.0801 -2.33968 7.70086 24.4633 +4070 4 5.35244 16.1813 39.5129 -32.5033 1.65679 -19.7071 +4071 6 24.3835 39.8482 14.0852 2.84697 7.18038 -0.286146 +4072 4 24.1877 40.6985 13.6429 5.77715 -11.144 2.19115 +4073 4 25.1234 39.4426 13.6288 0.754333 1.29636 -3.16103 +4074 6 19.9701 19.0136 10.1131 -5.22385 -12.8057 23.8822 +4075 4 19.1001 19.3633 10.3498 -0.643873 5.13605 -7.14836 +4076 4 20.1315 18.3631 10.8504 3.64009 16.176 -24.2707 +4077 6 45.2329 15.0638 25.3099 -19.5547 20.2245 12.2671 +4078 4 44.4482 15.622 25.4263 4.62838 7.04728 2.57625 +4079 4 44.8851 14.3824 24.752 0.155489 -22.5403 -14.0061 +4080 6 47.6439 32.9533 29.9771 4.38746 -1.69347 6.40492 +4081 4 47.8622 32.5347 30.8309 -5.05982 6.77924 -7.14273 +4082 4 46.6855 33.0215 29.8843 -3.06966 -4.44082 4.14054 +4083 6 9.30872 14.1631 35.6268 19.7088 14.7601 29.7215 +4084 4 10.221 13.8687 35.4779 -5.99131 -8.3331 -9.89462 +4085 4 9.36538 14.5282 36.5395 -10.4264 -5.45721 -18.9107 +4086 6 0.534978 28.7509 32.1461 -15.0727 14.1973 -4.1115 +4087 4 0.468283 29.1163 31.2513 -2.72678 6.96628 5.64212 +4088 4 0.834469 27.866 31.9601 7.81775 -11.1437 7.49829 +4089 6 26.1375 14.1816 40.8286 20.1166 -40.7048 30.4826 +4090 4 26.3241 13.5573 41.5993 3.0023 20.8863 -27.3959 +4091 4 25.2151 14.3343 40.9319 -22.5068 13.4131 -3.44564 +4092 6 38.0468 1.72227 37.358 -19.6589 11.4537 -4.22791 +4093 4 38.2764 1.77906 36.4154 -1.14244 -2.14966 7.97792 +4094 4 37.182 2.20858 37.4052 20.9639 -13.8426 2.93072 +4095 6 43.3928 21.0193 0.385094 -33.4221 -4.11839 13.5226 +4096 4 43.2305 21.8771 0.864972 20.5484 -13.2955 -16.2126 +4097 4 44.243 20.9573 41.8451 7.78799 18.4844 3.58779 +4098 6 29.7343 12.3918 17.0888 -10.4088 14.6249 -44.7733 +4099 4 30.3573 13.1084 17.3121 -1.69191 -12.5137 15.8564 +4100 4 29.5365 11.7717 17.7855 9.28071 1.18848 24.195 +4101 6 21.0845 11.002 35.643 19.2467 11.9534 29.728 +4102 4 20.8387 11.9292 35.5336 -5.23529 -0.657509 -1.91086 +4103 4 20.6782 10.509 34.9529 -15.7216 -13.7754 -25.5995 +4104 6 24.3584 22.1274 17.054 -19.116 4.6391 -13.6617 +4105 4 24.8062 22.8618 16.6504 0.246813 15.5697 -7.02352 +4106 4 25.0581 21.6899 17.4914 19.3443 -19.237 19.9016 +4107 6 44.2632 9.62803 6.15095 12.4515 -7.11379 4.41615 +4108 4 44.6939 9.46248 5.31272 4.1824 -3.3463 -6.13814 +4109 4 43.3875 9.94101 5.94426 -13.441 6.05535 2.74078 +4110 6 40.7983 2.89203 6.29118 6.30341 -5.06299 2.94692 +4111 4 40.283 3.08384 7.0886 -2.93464 8.08246 -11.2803 +4112 4 40.6425 3.53992 5.58152 -5.48248 3.30556 7.46891 +4113 6 23.4927 29.787 25.2074 -17.9847 -14.6764 23.1638 +4114 4 22.9663 29.9524 24.4255 0.505661 2.84572 -7.25135 +4115 4 24.3189 30.243 25.1366 19.4862 15.0746 -12.06 +4116 6 45.2253 20.6067 7.48804 -4.5495 -5.9569 -0.737791 +4117 4 44.4771 20.6075 6.85512 7.98227 -4.73543 5.3389 +4118 4 45.4897 19.6858 7.65762 -3.7219 7.49041 -4.48952 +4119 6 44.1869 26.5802 16.6604 -2.53584 -23.4697 22.3036 +4120 4 44.4278 26.4187 15.7655 11.491 9.41288 -34.0672 +4121 4 43.9629 25.6676 16.9 -3.51956 3.82806 13.7521 +4122 6 23.5847 27.0608 18.0875 4.92857 -1.63386 -8.1099 +4123 4 23.1417 26.2886 17.6568 -1.85204 16.5134 12.3838 +4124 4 22.9956 27.5067 18.7318 1.2523 -15.787 -12.8337 +4125 6 45.1423 16.1006 8.91925 -12.5826 4.07054 -12.5551 +4126 4 44.1756 16.0018 8.7625 13.8686 2.25455 7.61002 +4127 4 45.2849 15.9649 9.86163 -1.87368 -3.25302 7.37304 +4128 6 39.0195 15.168 5.20911 22.9796 -5.95468 -13.3261 +4129 4 39.8169 15.5451 4.76197 -16.8333 -0.501818 4.44847 +4130 4 38.2997 15.7872 5.12886 -6.79784 14.0419 -3.1922 +4131 6 40.4728 4.77172 20.098 -25.5728 -7.96759 5.38455 +4132 4 41.2852 4.73631 19.62 25.1414 0.345713 -9.53623 +4133 4 40.6586 5.20983 20.9254 2.90807 4.2574 9.49937 +4134 6 35.8334 28.4358 39.8978 -29.6544 -30.7382 0.627816 +4135 4 35.064 27.7738 39.8775 30.8234 30.4338 1.60118 +4136 4 36.4992 28.0138 39.3349 2.0747 -0.608826 -0.916217 +4137 6 26.5626 3.56604 2.67563 -12.8067 -1.70274 -2.52813 +4138 4 26.0244 3.493 1.8476 6.72613 8.7381 24.6483 +4139 4 26.0719 4.09981 3.36162 5.66066 -13.1585 -23.5937 +4140 6 2.95645 21.6514 17.6824 -3.82104 6.40043 0.291571 +4141 4 2.91294 22.1823 18.4797 -6.37673 0.600795 10.7096 +4142 4 3.68258 22.033 17.1814 1.62588 2.51689 -6.09233 +4143 6 12.886 25.0591 25.9256 19.9254 19.7817 -8.37483 +4144 4 13.3104 25.904 25.618 -13.2675 -16.998 3.60223 +4145 4 12.0452 24.9678 25.4656 -4.65807 1.85418 -5.64346 +4146 6 41.5793 20.6554 14.1751 9.92193 3.46069 0.25892 +4147 4 42.3122 20.2044 13.7523 0.767115 -12.7084 -7.64783 +4148 4 41.9959 21.4893 14.4245 -8.84771 2.34114 1.73285 +4149 6 1.24495 39.6039 11.5378 16.0363 -42.6363 3.17437 +4150 4 1.64626 38.7705 11.134 -18.3255 36.4754 4.46196 +4151 4 1.41802 39.4632 12.4909 -5.9615 12.3362 -8.98123 +4152 6 16.0218 39.0109 34.0619 -0.331369 12.6721 -5.4452 +4153 4 15.5475 38.1996 33.7806 5.75571 19.7523 -4.5346 +4154 4 15.9899 39.7855 33.4251 -7.29137 -28.599 9.21448 +4155 6 20.567 7.02475 25.5588 2.3848 7.82756 -0.6535 +4156 4 20.909 7.86076 25.1782 -7.45606 -9.2474 3.61042 +4157 4 19.6275 6.99553 25.3185 5.42042 5.25175 -3.5088 +4158 6 45.1928 25.5902 39.1787 -21.925 2.17874 18.9559 +4159 4 45.8631 26.0435 38.6892 20.8233 13.1115 -15.3132 +4160 4 45.3324 24.6675 39.0115 4.42968 -17.7425 -2.36405 +4161 6 19.9342 40.1138 28.2835 12.5964 -14.0671 -7.25792 +4162 4 19.0067 40.1593 28.0096 1.46425 5.68018 7.52545 +4163 4 20.128 40.8224 28.917 -7.48392 0.334406 -3.99949 +4164 6 26.4878 14.2069 27.3684 6.98603 -7.23951 -28.1548 +4165 4 25.5412 14.1932 27.2537 -20.7302 0.754551 -2.34698 +4166 4 26.606 14.4537 28.2745 0.836708 4.29804 26.5652 +4167 6 51.3489 25.9487 3.45136 10.7849 20.7191 -13.686 +4168 4 51.0453 25.2386 4.01334 -1.8549 -15.8565 1.21982 +4169 4 51.853 25.5737 2.69356 -6.32678 0.0553236 13.0587 +4170 6 20.1633 26.1247 2.67289 8.83438 -16.1267 5.68002 +4171 4 20.5345 25.2411 2.88723 -1.43181 13.9101 -1.64203 +4172 4 19.9438 26.1088 1.72974 -0.778515 0.427063 3.21599 +4173 6 3.13549 11.9681 27.2232 16.3616 22.3682 9.86323 +4174 4 2.68005 12.663 26.7181 4.92926 -3.58697 -0.471129 +4175 4 3.70389 12.4466 27.8862 -15.0224 -10.9098 -14.9284 +4176 6 30.1793 26.3687 4.00051 28.7119 -30.2966 58.1206 +4177 4 30.7801 25.8341 3.46925 -1.584 2.83444 -17.1702 +4178 4 29.6371 26.9341 3.51662 -25.563 30.6813 -37.7958 +4179 6 19.3205 20.6733 30.5441 -31.721 -6.25106 8.6959 +4180 4 19.1895 21.5008 31.0287 11.509 1.10551 -1.6952 +4181 4 20.2026 20.5869 30.2 22.6938 9.52703 -0.947482 +4182 6 13.5381 36.2475 0.344803 0.685356 24.2985 -17.2657 +4183 4 13.9232 37.1122 0.0997808 14.0363 -10.2996 17.9143 +4184 4 12.867 36.2368 41.5779 -17.3214 -19.7281 -1.62589 +4185 6 13.6931 21.7661 35.9637 -11.3229 -11.9655 -19.5688 +4186 4 13.4645 21.416 35.0694 1.68887 6.71419 14.5774 +4187 4 14.5559 22.1488 35.8465 12.3178 6.48213 0.887249 +4188 6 39.4176 1.76287 25.342 34.0854 -16.9064 9.57103 +4189 4 40.0026 2.33061 25.8435 -14.6367 28.4588 7.32056 +4190 4 40.0689 1.04185 25.2643 -19.5027 -7.65211 -10.5764 +4191 6 18.2964 6.13492 35.8264 -1.82227 -5.92686 -23.3299 +4192 4 18.1639 5.26767 36.254 2.04199 12.8657 6.45456 +4193 4 18.4232 6.85005 36.4651 0.375802 -9.94466 7.47089 +4194 6 2.53148 24.639 10.0969 -49.4669 34.6161 -0.50772 +4195 4 3.3243 24.1433 10.0889 43.7683 -7.59463 9.24933 +4196 4 2.65209 25.5465 10.4987 14.0059 -27.2835 -7.72375 +4197 6 35.8204 9.94567 1.34298 17.6587 14.9905 11.506 +4198 4 36.311 10.4135 0.64327 -4.10869 -3.12473 7.53129 +4199 4 36.1923 10.315 2.19711 -13.0886 -16.0695 -26.9686 +4200 6 29.0171 17.933 41.5847 -7.4648 10.4738 41.1296 +4201 4 28.4325 17.2741 41.1888 4.90819 -0.226834 -17.309 +4202 4 29.634 18.3354 40.9804 6.59061 1.40283 -25.0927 +4203 6 46.0097 27.0807 25.8707 -17.7195 2.90801 -6.40423 +4204 4 46.7639 26.9189 26.4445 5.86789 -6.79057 7.62258 +4205 4 45.3727 26.3443 25.9794 8.73043 2.74283 1.98831 +4206 6 28.1087 10.6569 35.9055 -15.3417 -26.5964 -30.9314 +4207 4 27.3182 11.0018 35.4375 11.5227 2.30745 10.116 +4208 4 28.4572 11.2922 36.5111 4.26863 23.9808 15.1461 +4209 6 25.95 20.1976 24.7821 3.31321 9.63686 -4.79579 +4210 4 26.7637 20.7132 24.6155 -9.40037 -7.04512 10.7501 +4211 4 25.7749 20.1865 25.7378 6.19451 4.49283 1.81458 +4212 6 32.2481 30.2487 10.2005 -0.567171 -33.888 25.4585 +4213 4 32.5217 30.8918 9.54162 14.407 -2.03846 -6.18424 +4214 4 32.9483 29.5597 10.4163 -8.30199 27.6945 -16.8968 +4215 6 5.04696 34.3919 23.8165 18.9071 9.10073 -2.65681 +4216 4 5.8517 34.9395 23.7378 -5.43375 -12.4066 7.00495 +4217 4 4.47737 34.8578 23.2154 -15.6684 -1.23826 -5.97721 +4218 6 29.6446 34.9396 23.1073 8.37026 13.2143 1.46186 +4219 4 30.146 35.227 23.8877 -4.79805 -2.96005 -2.8646 +4220 4 29.6355 33.9874 23.1398 -0.169507 -13.2925 4.62646 +4221 6 52.2021 25.2197 36.2484 0.203165 -13.9358 18.8619 +4222 4 51.9199 25.3821 37.1814 5.20177 -0.668093 -22.6011 +4223 4 52.2823 24.2449 36.2046 0.468647 8.20491 -0.432122 +4224 6 6.9564 41.2598 14.9786 17.963 -12.3423 -19.5336 +4225 4 7.05881 41.0384 15.8913 -5.14113 -1.34859 16.0369 +4226 4 7.66895 40.7276 14.5577 -14.5347 12.9973 2.09466 +4227 6 27.6566 39.1405 4.67566 -15.1179 -12.1251 22.0677 +4228 4 26.8424 38.6352 4.89635 10.0979 9.09612 -9.05456 +4229 4 28.2356 39.0161 5.44259 -0.0995191 -2.46215 -4.35417 +4230 6 44.4488 15.8848 30.3925 -17.4686 4.63448 -32.2897 +4231 4 43.6243 16.41 30.3099 13.0937 -10.0294 9.08699 +4232 4 44.649 15.6212 29.457 1.77951 4.94888 23.2191 +4233 6 27.3024 38.1054 13.0907 0.224949 -17.5042 -4.12929 +4234 4 27.6483 37.328 12.5833 -5.61487 10.2238 13.6353 +4235 4 27.1416 37.8221 14.0243 3.20236 0.189733 -16.1751 +4236 6 26.6663 32.9851 36.8362 -23.8807 -10.2072 10.655 +4237 4 27.4028 33.4987 36.5569 24.2269 11.6336 -10.1628 +4238 4 26.2735 33.5165 37.5295 -1.35435 2.25064 8.62378 +4239 6 26.3226 28.1988 31.7158 32.4613 11.5871 5.04411 +4240 4 26.7492 28.3346 30.8217 -6.54697 -0.873531 32.5908 +4241 4 26.9302 28.5068 32.4691 -17.7353 -8.90623 -33.5497 +4242 6 49.2114 35.7792 23.3295 1.46842 19.8344 9.76806 +4243 4 49.8184 36.2235 23.9243 -3.28067 3.63886 4.6357 +4244 4 49.746 35.0988 22.9506 10.5329 -22.9043 -16.5919 +4245 6 44.2369 15.3613 33.5367 -0.695853 -9.37614 14.4104 +4246 4 44.9539 15.1613 32.9326 3.59625 1.2978 -8.28609 +4247 4 43.6189 15.9562 33.0977 0.720121 5.36694 -8.04858 +4248 6 16.6517 35.2697 14.032 -14.9609 -5.91625 -15.8105 +4249 4 16.8478 36.086 14.4923 5.97715 10.4369 8.21626 +4250 4 15.7311 35.3947 13.7134 15.021 -1.16653 5.16189 +4251 6 45.2991 21.4701 12.0564 -47.5016 11.1637 19.3857 +4252 4 45.9844 21.105 11.5386 20.9258 -26.0087 -22.2564 +4253 4 44.5936 20.7913 12.2178 25.8967 12.3347 -6.55717 +4254 6 51.6438 5.33792 20.1099 7.42219 12.4384 36.9688 +4255 4 51.7517 5.79258 20.9932 -2.42789 -17.2577 -23.3969 +4256 4 50.9203 5.81642 19.7 -6.55397 4.36408 -6.3714 +4257 6 22.6153 27.305 0.955308 -12.5158 1.22245 6.52354 +4258 4 21.8819 27.8542 1.31405 9.62632 -7.19502 -8.89748 +4259 4 23.0385 27.8458 0.276527 0.370713 4.24399 -0.0338259 +4260 6 46.8868 12.1467 22.3289 10.3551 9.03073 -1.70047 +4261 4 46.473 12.5446 21.5671 -2.12653 7.07083 -14.4911 +4262 4 46.1639 11.6922 22.7348 -15.0603 -15.1984 17.3736 +4263 6 33.7555 5.60359 25.2366 8.41588 -11.9289 0.48427 +4264 4 34.4013 5.10188 24.7086 -2.4022 4.68399 3.96997 +4265 4 33.0757 5.86414 24.6127 -5.93503 4.46215 -0.558809 +4266 6 44.2476 18.1243 27.2334 30.0322 17.9475 -5.65933 +4267 4 44.0927 18.7931 26.5253 0.465456 -9.97561 17.2792 +4268 4 45.207 18.2464 27.4768 -29.0014 -6.50023 -5.41996 +4269 6 5.27814 37.006 29.0846 -42.995 37.8911 -11.235 +4270 4 4.83357 37.8684 28.7516 22.264 -36.721 16.075 +4271 4 6.19253 37.2033 29.2507 20.6764 5.54169 3.86921 +4272 6 20.033 5.01392 38.9409 6.34377 -32.2179 -4.45843 +4273 4 19.8009 5.56625 39.6765 -4.47316 13.7366 14.9565 +4274 4 20.2948 4.14306 39.3359 -6.8578 18.535 -7.22498 +4275 6 17.9112 2.77214 33.8677 -16.6976 6.01838 23.4157 +4276 4 18.6113 3.34266 33.5322 6.18073 5.31505 -2.96417 +4277 4 17.3526 3.28629 34.5246 17.6921 -17.568 -20.3177 +4278 6 5.56788 23.3774 22.3326 -7.55986 13.5725 18.1102 +4279 4 6.25354 23.3408 21.6412 1.32241 8.57002 8.68476 +4280 4 5.72116 24.1623 22.9232 3.31135 -14.4794 -19.5174 +4281 6 12.7438 28.0244 40.0809 14.6998 26.4392 -25.8726 +4282 4 12.8099 29.0023 40.1455 -0.120572 -14.3051 2.54846 +4283 4 13.1526 27.8611 39.1965 -9.74214 -4.86635 20.6942 +4284 6 50.5283 38.8014 28.4207 -10.7676 14.1923 -1.71082 +4285 4 51.0354 39.5212 28.0559 20.7423 0.788408 -10.014 +4286 4 49.7626 39.3052 28.7255 -7.2831 -13.6434 5.52883 +4287 6 33.5501 8.21498 17.8605 -32.9279 -35.4008 39.405 +4288 4 33.9027 8.87262 17.3189 24.9798 40.0041 -36.6225 +4289 4 33.9074 7.37462 17.5752 8.43731 -7.27798 -4.46199 +4290 6 34.6457 34.7004 17.7764 -12.4293 -15.9601 -10.9704 +4291 4 35.1223 35.3606 18.2944 6.48769 -0.751965 0.253856 +4292 4 35.2388 33.9528 17.5616 -1.14344 9.31979 5.2604 +4293 6 40.7233 5.29016 23.4005 8.26322 -6.33781 10.3585 +4294 4 41.4774 4.87923 23.8731 -9.49225 7.91527 -13.3731 +4295 4 40.0307 4.6112 23.3711 2.34129 5.18948 -0.0201455 +4296 6 16.9127 27.7621 14.4682 52.6044 -4.68653 -2.89351 +4297 4 16.0711 28.1345 14.4444 -59.8378 16.6137 -1.60006 +4298 4 17.4608 28.5627 14.561 1.7801 -9.46587 0.070581 +4299 6 29.0363 14.6633 5.00698 9.76413 -9.29226 13.7719 +4300 4 29.5096 13.8001 4.93115 -9.10936 16.1071 1.03458 +4301 4 28.802 14.7746 5.95339 2.50956 -1.40994 -14.9204 +4302 6 36.8445 17.7203 5.07362 13.6951 -24.032 -28.6565 +4303 4 36.3003 18.4061 5.45056 -9.17068 14.5835 0.43155 +4304 4 36.9783 17.8862 4.10178 -4.81067 2.65881 25.6667 +4305 6 27.7152 25.5071 34.8558 20.6182 -10.3116 10.9196 +4306 4 28.4128 25.1948 35.4689 -8.51497 -1.72528 -14.7569 +4307 4 27.3626 26.2325 35.3632 -10.8781 12.0961 2.58089 +4308 6 24.7577 17.2803 18.064 -3.70908 -2.75228 5.17573 +4309 4 25.2464 17.9619 18.5343 4.21458 5.85634 1.04617 +4310 4 24.0216 17.073 18.6635 3.98676 -0.349172 -5.54229 +4311 6 30.1887 1.57939 5.82314 -15.3902 21.7461 -57.8894 +4312 4 29.5204 1.81013 6.46928 0.301846 -2.58557 7.21893 +4313 4 29.8355 2.03332 4.95505 20.4457 -28.7719 49.9963 +4314 6 37.4518 25.9014 8.44867 -40.4019 -33.5071 29.4213 +4315 4 38.3881 25.8301 8.67833 5.27698 -2.9507 2.74989 +4316 4 36.9261 25.2192 9.0364 31.48 35.4073 -33.2345 +4317 6 24.7717 7.01585 2.25321 22.1725 6.13312 -2.42992 +4318 4 25.3573 6.36243 2.67285 -8.4103 6.94319 2.38151 +4319 4 23.8861 6.6751 2.35128 -10.8992 -4.25211 1.65182 +4320 6 25.7992 38.8457 10.7505 7.22571 37.8744 -16.0906 +4321 4 26.2906 38.615 11.5103 14.31 -23.6918 34.358 +4322 4 26.1189 39.766 10.6411 -14.7913 -5.88601 -10.6141 +4323 6 0.557249 13.5851 28.1314 4.10373 25.7622 10.4527 +4324 4 0.335523 12.7734 27.7191 -4.86664 -22.4284 -15.6315 +4325 4 0.332586 13.4422 29.0593 -0.0574933 0.663208 0.855409 +4326 6 20.4027 17.1068 12.0342 -11.148 -26.8285 -23.5414 +4327 4 20.2541 17.2545 12.9674 -4.18463 -1.09026 14.619 +4328 4 19.9228 16.2663 11.7843 12.058 20.2306 8.20324 +4329 6 30.9875 7.38585 16.6706 43.1327 18.1844 -1.13431 +4330 4 31.2844 7.10043 15.7746 -9.95685 2.73348 15.1831 +4331 4 31.8198 7.8213 17.056 -34.7561 -19.1709 -8.28734 +4332 6 10.1956 5.78615 12.1691 19.1166 9.414 40.461 +4333 4 10.1305 6.30649 11.4071 -1.6074 30.0602 -42.5686 +4334 4 9.61456 5.08708 11.9844 -30.6818 -38.1141 -6.43609 +4335 6 18.4382 31.3444 24.1606 1.21336 -6.12525 2.83497 +4336 4 18.3965 30.3858 24.3134 -0.788465 1.61506 0.642095 +4337 4 18.2608 31.7571 25.0112 -0.825834 1.26386 0.0223154 +4338 6 27.8905 29.2615 29.2809 39.8074 15.5588 -29.008 +4339 4 28.4007 29.5348 28.4528 -32.3375 -5.53357 22.8869 +4340 4 28.6323 28.9656 29.8273 -8.8667 -4.73078 13.1255 +4341 6 38.3648 15.4483 29.7818 29.0993 -31.9427 29.9284 +4342 4 38.2401 14.49 30.0972 1.05022 38.774 -16.5136 +4343 4 39.2299 15.7257 30.2111 -34.0699 1.82394 -15.2271 +4344 6 21.7074 34.7851 5.58078 8.19375 -39.9271 5.99876 +4345 4 21.4944 33.8203 5.80476 0.548141 38.153 -5.97617 +4346 4 20.9458 35.3238 5.82701 -5.25279 -7.50871 2.73382 +4347 6 18.2117 16.8293 1.01571 -12.7233 9.06437 9.63769 +4348 4 17.5846 17.1799 0.363518 5.67247 -6.87112 -0.25098 +4349 4 17.8106 17.1001 1.86952 7.78128 -5.5379 -6.7416 +4350 6 43.5131 18.5098 39.3469 22.8992 -24.809 -24.744 +4351 4 42.9473 19.1501 39.756 -14.025 22.4758 -1.21679 +4352 4 43.733 18.7829 38.41 -14.2449 3.90475 27.8798 +4353 6 17.7973 10.0724 35.5497 11.3899 1.25644 -17.5776 +4354 4 17.9076 9.35875 36.1674 -1.9111 -9.85084 12.7139 +4355 4 18.4727 9.8826 34.8661 -11.1758 5.45367 7.50841 +4356 6 36.5836 30.5676 29.0795 -26.735 36.4018 -15.4516 +4357 4 36.5101 31.4618 28.6208 1.83791 -30.0083 14.6126 +4358 4 37.4767 30.2665 28.9506 20.8385 -5.81304 -4.31186 +4359 6 38.5024 35.9654 10.4302 15.5283 7.61871 55.4477 +4360 4 38.713 36.6589 11.1463 -7.3207 -22.805 -33.4203 +4361 4 38.3781 35.1576 10.9824 1.19538 10.4075 -12.7486 +4362 6 43.3976 18.7941 34.3717 -4.38817 -12.2014 30.3889 +4363 4 43.0627 18.1963 33.6763 0.988603 1.53223 14.3474 +4364 4 43.2603 18.4022 35.293 0.0857578 9.32555 -37.8245 +4365 6 11.0576 40.22 6.11206 -6.0837 -9.04747 -4.15047 +4366 4 11.6426 40.8981 6.46389 1.08734 7.77423 2.35531 +4367 4 10.1474 40.5638 6.06331 9.30243 4.06404 0.87098 +4368 6 48.3282 13.7431 24.4718 -8.87905 25.3224 16.0087 +4369 4 47.8536 13.4091 23.7195 -8.5266 -8.47545 -16.9724 +4370 4 47.8942 14.6072 24.6749 14.3726 -19.4181 -2.72093 +4371 6 1.47819 25.7805 23.7819 -0.0731812 -13.4431 -3.72387 +4372 4 0.822875 26.4404 23.4927 11.4147 5.84295 7.97453 +4373 4 2.19403 26.202 24.2849 -5.19934 9.21725 -1.17005 +4374 6 20.5754 0.0393205 21.1081 25.6075 5.05031 -17.3956 +4375 4 19.8484 0.361847 21.622 -17.4675 -5.38456 12.9096 +4376 4 20.5586 40.9849 21.0455 -11.1839 1.66381 7.6849 +4377 6 37.6642 12.8991 30.7037 -9.9457 -20.8438 -29.8221 +4378 4 37.1371 12.462 29.9889 18.2914 6.1257 8.16018 +4379 4 36.9745 13.1334 31.2979 -14.5618 11.4049 21.409 +4380 6 49.47 17.3794 9.25364 5.30826 8.19981 -9.14457 +4381 4 48.5231 17.6061 9.31556 15.6584 -1.48937 -5.70503 +4382 4 49.8852 17.9254 8.53549 -14.9109 -12.0851 17.4703 +4383 6 34.3662 5.35535 17.144 13.1974 2.57034 -29.0571 +4384 4 34.5198 5.2998 16.166 0.54303 4.43319 20.4174 +4385 4 33.4623 5.07036 17.243 -16.3394 -6.24992 8.38082 +4386 6 14.7833 27.6665 0.0728061 -6.74966 -7.64198 -7.69033 +4387 4 13.9925 27.8402 41.4242 12.1928 3.48747 9.75107 +4388 4 15.1668 28.5017 0.401621 -7.96817 -0.0208253 -5.02821 +4389 6 48.8656 15.5206 20.7458 -9.86138 0.136748 20.6241 +4390 4 49.0651 16.3952 20.4263 0.209458 6.72405 -7.85333 +4391 4 49.1204 14.8922 20.0789 6.79298 -9.16117 -16.8166 +4392 6 23.807 40.3882 20.3905 -3.398 23.5063 24.1729 +4393 4 23.5208 41.0259 21.1064 9.42377 -19.8715 -22.5683 +4394 4 24.7282 40.1652 20.6096 -6.91059 4.34471 -3.10789 +4395 6 35.1847 31.5046 13.7021 -31.0181 23.9456 -35.1619 +4396 4 34.2309 31.3725 13.4471 24.927 2.88592 7.27171 +4397 4 35.3946 30.8036 14.2945 4.95161 -20.634 19.3451 +4398 6 10.9658 9.01332 39.5058 -15.2714 21.9147 -18.395 +4399 4 10.5965 9.92979 39.4 9.97221 -25.6919 2.69722 +4400 4 11.1763 8.90125 40.4322 -2.36933 4.41176 3.08643 +4401 6 53.2091 4.88966 16.6226 -14.1926 -12.3632 -40.3028 +4402 4 53.7513 5.3458 17.242 7.58091 5.46958 35.753 +4403 4 52.4727 4.38631 17.0042 6.19997 4.37068 9.30068 +4404 6 7.84194 33.803 26.1542 28.433 15.6582 -32.2535 +4405 4 7.6241 34.0763 27.0539 6.31302 8.01731 -0.629847 +4406 4 8.43319 34.4994 25.6777 -29.4311 -29.3345 32.8186 +4407 6 31.3263 27.9445 6.27534 4.23256 -31.0286 -11.1959 +4408 4 31.9071 27.4889 6.92578 -8.71467 11.4818 -6.48617 +4409 4 31.157 27.2952 5.54778 3.06851 13.2477 11.4148 +4410 6 31.3665 2.16522 41.0549 8.67281 8.84877 18.675 +4411 4 31.764 2.22522 0.0553479 -13.0589 -8.62932 -24.7178 +4412 4 31.1679 1.24258 40.8683 -0.324156 -6.15668 4.61941 +4413 6 33.7659 4.25511 35.8987 -17.0312 -3.82062 1.06926 +4414 4 34.343 3.86214 36.5812 -9.75418 2.24627 -3.55813 +4415 4 32.8029 4.08293 36.1352 33.1171 1.27305 -1.46623 +4416 6 47.9658 16.0637 29.8469 2.67107 -7.93457 21.4822 +4417 4 48.7643 16.2814 30.3583 0.589987 0.219824 -12.8585 +4418 4 47.4335 15.6159 30.5321 -1.60863 4.8928 -15.0046 +4419 6 49.3312 10.0914 28.5924 -0.28152 -2.80953 -5.35856 +4420 4 48.5695 10.6519 28.8218 4.15282 -2.34898 -5.74021 +4421 4 49.4995 10.1231 27.6243 -2.44246 2.9592 14.5426 +4422 6 21.4058 27.7857 29.7524 8.26148 -8.5709 13.934 +4423 4 21.8935 27.2574 30.4222 -7.07544 0.199766 -18.4014 +4424 4 21.2999 28.6278 30.1835 -3.48366 18.9655 1.67033 +4425 6 11.6744 39.4982 25.8468 7.90293 7.18169 -2.58674 +4426 4 12.2285 38.7361 26.0681 1.40058 3.92388 1.36909 +4427 4 10.8023 39.1241 25.7384 -12.6269 0.672841 -0.990747 +4428 6 22.9696 39.3076 7.85132 -6.07512 -3.4122 -1.68244 +4429 4 22.2682 38.6524 7.98148 0.173976 5.86283 1.52023 +4430 4 22.7132 40.0561 8.41581 1.67877 -3.24138 -2.90234 +4431 6 42.551 35.9177 31.3369 11.821 -63.1978 11.5341 +4432 4 42.5803 35.466 30.4647 -4.4966 22.226 11.3725 +4433 4 42.4036 36.8376 31.2573 -6.84366 36.9754 -14.9488 +4434 6 33.6582 14.7374 3.97797 20.0935 -7.17859 -40.4554 +4435 4 32.8645 15.2412 4.10613 -20.5582 11.3796 6.05129 +4436 4 33.8494 14.8388 2.99484 -4.26498 -3.76663 30.6135 +4437 6 36.6985 8.59579 17.521 17.5186 -20.4505 -17.8166 +4438 4 37.2174 8.05238 16.87 -10.1577 15.2162 18.3492 +4439 4 36.2061 9.2161 16.9727 -6.85471 3.87096 1.58869 +4440 6 20.8134 32.4132 17.3224 -0.15138 -19.2041 8.32641 +4441 4 20.2101 33.0681 16.9297 -8.31182 -6.81981 10.9196 +4442 4 20.3788 31.7527 17.9441 5.10322 26.2393 -19.6477 +4443 6 20.7088 35.3183 14.0957 -11.7768 -25.3725 -13.8548 +4444 4 21.261 35.5893 13.3574 6.77827 9.37653 -4.07387 +4445 4 20.8679 35.9028 14.8214 6.04206 13.2639 9.85712 +4446 6 20.2377 2.51389 40.1721 -7.12285 -8.41588 24.6249 +4447 4 19.7963 2.31331 41.0421 14.3479 1.04867 -24.2175 +4448 4 20.7189 1.71371 39.9103 -4.456 1.41042 1.49289 +4449 6 15.0332 14.4679 0.20602 13.2809 -6.14192 -34.7112 +4450 4 15.5535 13.6508 41.8516 -13.9549 30.8146 5.37449 +4451 4 15.3124 15.2392 41.5458 -1.11857 -25.4589 11.3055 +4452 6 24.8198 37.3334 18.5262 -9.71694 12.1129 21.4379 +4453 4 24.5044 38.0178 17.9266 6.55828 0.975012 -4.85481 +4454 4 24.4839 37.6255 19.4009 7.37292 -12.3795 -13.3571 +4455 6 3.16023 27.7824 5.25746 -7.59771 -9.49442 8.09122 +4456 4 2.57386 27.9573 6.05068 26.7372 -11.3185 -11.6141 +4457 4 4.04718 27.3724 5.4685 -26.4098 5.90831 3.92345 +4458 6 37.1274 39.059 36.0582 -20.0626 39.3499 3.12364 +4459 4 37.4397 39.697 36.7497 0.155645 -22.9334 -11.3782 +4460 4 37.5741 38.2261 36.1006 18.9616 -13.4483 8.05827 +4461 6 41.3496 16.372 3.85306 -8.55617 -26.9153 -3.74777 +4462 4 41.2863 17.3336 3.84263 10.0449 1.9656 13.5452 +4463 4 42.0245 15.9886 4.46176 -7.16622 24.1057 -6.4954 +4464 6 15.5715 3.1806 35.3543 4.49903 -8.79025 -44.1337 +4465 4 15.0747 3.51322 34.5661 7.45265 -4.29831 20.3405 +4466 4 15.2394 3.62675 36.1076 -11.9729 17.6287 21.2524 +4467 6 33.1697 24.252 7.98021 17.4163 -35.2043 24.5175 +4468 4 33.373 24.4892 7.07941 -5.88693 14.0606 -13.9779 +4469 4 32.5854 24.8767 8.38373 -10.6809 23.5743 -3.02942 +4470 6 35.8792 29.7453 15.5891 -14.351 2.75051 -7.10357 +4471 4 36.7674 29.6271 15.8378 44.9858 5.9786 2.16229 +4472 4 35.4705 29.0828 16.1298 -19.5083 -3.35284 8.18061 +4473 6 17.5951 36.8258 41.8642 -13.8657 0.640745 -39.4401 +4474 4 18.0986 36.7885 0.752491 19.5286 0.61142 14.8967 +4475 4 18.204 36.9888 41.0995 -4.16013 -2.78766 23.3657 +4476 6 26.5622 4.14757 31.1303 -11.2209 -47.8968 -15.8259 +4477 4 27.2883 4.63526 31.456 28.856 27.2634 11.544 +4478 4 26.9475 3.23966 30.9928 -12.9924 23.1667 5.46977 +4479 6 31.9456 1.33308 34.4467 -12.9904 6.64728 -11.4505 +4480 4 32.8071 1.19449 34.8725 -11.0783 -3.65615 8.33208 +4481 4 31.1956 1.0725 35.0172 18.2758 0.413953 2.527 +4482 6 24.503 14.7492 2.38048 9.24208 -0.0712211 -0.802907 +4483 4 24.1928 14.0003 2.93847 14.4388 11.7071 -7.35684 +4484 4 25.4689 14.9243 2.53228 -19.8697 -9.93034 3.69906 +4485 6 25.7634 20.9148 27.525 0.946636 -0.977661 -1.30084 +4486 4 25.4997 20.5428 28.395 3.38508 9.32598 -11.7317 +4487 4 25.6529 21.8806 27.5755 0.284497 -3.23384 4.14496 +4488 6 18.1477 40.1511 30.6505 2.638 -12.7558 5.82509 +4489 4 18.5379 39.2542 30.773 0.361891 20.0487 -3.45439 +4490 4 18.8736 40.7943 30.5754 -0.793328 -5.73314 0.616918 +4491 6 46.8137 23.9108 24.5765 -6.45001 25.2139 -38.2053 +4492 4 46.156 24.4917 24.0674 25.2521 -23.4518 17.6745 +4493 4 47.3533 23.4819 23.8873 -7.92808 3.44465 4.72259 +4494 6 45.5993 22.6806 26.5072 -4.87261 3.12825 -8.14378 +4495 4 46.0946 22.9584 25.7273 -3.42504 -3.72677 5.16847 +4496 4 46.0209 23.1613 27.2227 -5.79148 -3.32105 5.25932 +4497 6 20.0977 4.47574 26.7104 -1.85738 36.2438 14.3308 +4498 4 20.3766 5.37803 26.4593 -10.8474 -9.08605 12.6513 +4499 4 20.6066 3.98633 26.1049 14.7704 -34.5311 -24.6657 +4500 6 35.268 26.6035 12.5547 25.3434 4.5593 25.1203 +4501 4 35.7054 25.7374 12.5354 -13.4481 2.49909 -6.64065 +4502 4 35.8431 27.0669 13.1929 -15.092 1.56141 -12.9558 +4503 6 3.25549 33.9664 12.2985 -21.2488 -6.99508 3.93395 +4504 4 2.30606 33.7392 12.3085 7.5225 -4.25393 -1.25154 +4505 4 3.25844 34.917 12.332 8.53638 16.5693 1.24934 +4506 6 36.6808 1.27299 25.5856 -28.051 -2.86161 17.5249 +4507 4 37.6164 1.46673 25.6835 8.21338 5.71919 3.59986 +4508 4 36.1703 1.6124 26.3685 15.6278 -2.9361 -18.4357 +4509 6 16.8737 4.664 24.0353 -31.9925 -2.01789 -27.2632 +4510 4 15.8786 4.73848 23.8401 40.5517 -2.65221 8.73903 +4511 4 17.2589 4.19458 23.2519 -3.48506 7.68373 17.7614 +4512 6 39.6701 15.0742 7.83356 -1.71206 -7.05123 2.14494 +4513 4 39.2725 14.2274 8.02711 2.44544 -9.24519 17.4119 +4514 4 39.3892 15.1326 6.9218 7.69265 14.011 -7.76766 +4515 6 9.96731 20.1909 2.92864 -13.1382 1.0323 -16.144 +4516 4 9.71565 20.5309 2.05786 3.65664 7.03968 6.64426 +4517 4 9.8995 19.2377 2.78093 4.24026 5.10291 12.3576 +4518 6 23.4077 4.6159 15.27 -3.48308 -16.1533 -1.5067 +4519 4 23.619 4.71624 14.3536 6.29203 -7.01184 -22.1313 +4520 4 23.1672 5.50294 15.4683 -4.33935 19.8524 20.6561 +4521 6 23.5267 41.6518 17.9122 -9.44104 0.807914 21.3506 +4522 4 23.7067 41.2659 18.7956 7.59245 -0.294373 -11.029 +4523 4 22.6339 0.0834245 18.0732 1.82991 3.48892 -13.1537 +4524 6 30.9316 4.82324 1.33107 45.9774 51.3713 7.99935 +4525 4 30.5768 4.02682 1.05687 -28.0042 -54.4029 -17.3695 +4526 4 31.8094 4.8761 0.879215 -15.6392 -0.833181 8.5221 +4527 6 29.2201 33.7587 18.5991 58.073 2.92721 -1.85527 +4528 4 30.1837 34.1183 18.6008 -42.2538 -17.2347 0.0641557 +4529 4 28.6837 34.5413 18.5643 -15.6262 17.5996 3.33909 +4530 6 23.1221 16.7099 3.68521 11.8431 -16.3115 0.0733348 +4531 4 23.6562 16.338 2.95547 -9.45134 2.67217 9.8165 +4532 4 23.048 17.6538 3.54099 -2.31098 6.59774 -1.54538 +4533 6 34.8961 26.7639 31.7325 -1.99602 4.46994 3.67284 +4534 4 35.0929 27.7139 31.562 -2.18198 -17.8875 -5.58085 +4535 4 35.0252 26.2302 30.9312 2.47742 18.1005 -1.54363 +4536 6 7.11189 40.7663 20.959 14.901 4.90705 15.7674 +4537 4 6.49418 40.4573 20.3006 -5.17655 -2.88906 -15.6427 +4538 4 7.9749 40.9101 20.5297 -6.61986 -3.78335 -7.15935 +4539 6 52.4451 9.69387 11.9379 -8.46192 -13.0679 -16.1645 +4540 4 52.1167 8.90553 11.4509 5.46474 18.3719 13.4625 +4541 4 53.1134 10.0871 11.3593 -6.16158 -0.354597 4.80602 +4542 6 12.0344 32.7576 27.7445 1.28323 7.36678 12.5499 +4543 4 11.2848 32.2741 27.3627 7.37999 2.33687 -5.47139 +4544 4 12.7987 32.654 27.1746 -1.40521 -5.62475 -4.84597 +4545 6 15.7821 18.5441 0.84801 8.76354 -4.35468 -11.8188 +4546 4 16.4439 18.9467 1.42581 -3.0166 1.81121 1.10538 +4547 4 14.9492 18.5892 1.29924 -12.8156 0.756803 9.02992 +4548 6 30.9925 13.9418 7.42386 -4.40747 -9.92517 -19.1249 +4549 4 31.0137 13.4754 6.53341 6.38174 17.9129 28.0089 +4550 4 31.6996 14.6103 7.52177 -5.32565 -11.3142 -7.68087 +4551 6 23.9405 39.5605 3.5435 10.8606 -6.43074 -8.73391 +4552 4 24.3095 38.7805 4.04208 -2.00396 18.4511 -18.0645 +4553 4 24.6123 39.8651 2.88148 -9.69774 -9.50421 15.8523 +4554 6 53.2462 13.9551 2.00337 -15.5118 -12.0942 -3.71099 +4555 4 54.104 14.269 2.28215 12.5804 5.35006 1.30654 +4556 4 53.0522 14.3304 1.13281 7.32968 -0.777694 2.32044 +4557 6 29.4483 26.4268 7.81741 -0.171572 11.4439 -18.4732 +4558 4 29.8672 26.7876 7.00927 -3.33338 -4.99995 18.6366 +4559 4 28.5088 26.3872 7.58736 -4.03891 -2.78124 5.15679 +4560 6 24.6251 23.6043 31.0935 -26.8137 17.7603 -44.4691 +4561 4 23.7139 23.2229 30.9355 29.773 11.0738 8.78977 +4562 4 24.7983 24.2076 30.2965 -2.98074 -30.8217 36.523 +4563 6 33.658 19.3188 40.511 -4.29932 4.0975 7.85681 +4564 4 33.8365 18.6271 41.1728 0.0947513 0.993086 -5.72158 +4565 4 34.3002 19.2334 39.7953 0.390848 -1.03282 -3.03706 +4566 6 0.558986 35.9852 14.2205 11.1667 11.0015 21.0521 +4567 4 1.21386 36.1432 14.9149 3.92292 -5.96876 -2.97707 +4568 4 0.043734 36.7876 14.3014 -15.3768 6.08493 -10.5247 +4569 6 7.05222 12.7587 15.7802 -26.1824 -15.4106 14.8382 +4570 4 6.35773 12.5373 16.4499 19.2033 7.53925 -13.5919 +4571 4 6.88557 12.0803 15.1093 4.12905 5.75416 0.888 +4572 6 7.8802 3.87979 22.4264 4.564 -30.6165 13.1651 +4573 4 7.61737 4.55637 21.8154 -5.12813 13.4305 -13.5146 +4574 4 7.59435 3.01808 22.0419 3.92228 16.9329 8.71162 +4575 6 50.747 32.0919 16.246 0.584829 29.9532 -6.88448 +4576 4 49.8575 31.8158 16.477 -3.66132 0.0213613 -0.234359 +4577 4 50.6533 33.048 15.9617 2.92819 -31.696 10.1835 +4578 6 15.3083 18.2099 30.0577 17.4273 -12.3999 25.5818 +4579 4 14.8795 18.523 29.2753 -13.2188 2.60124 -19.4058 +4580 4 14.9888 17.3027 30.2404 2.47215 8.3937 -6.40515 +4581 6 36.7253 25.4508 33.3862 -30.1432 30.6395 -17.6873 +4582 4 35.9871 25.9696 32.8546 42.334 -36.2451 27.5582 +4583 4 36.7428 24.5171 33.143 -7.68133 1.91065 -3.3758 +4584 6 16.5208 21.8449 20.262 -11.2097 8.64672 -3.63533 +4585 4 16.6085 20.9267 19.9682 1.68058 -0.497742 -2.90804 +4586 4 16.3112 22.3946 19.4823 4.36577 -8.59001 6.07269 +4587 6 44.2833 3.11948 30.0766 -7.99673 -6.73576 30.9987 +4588 4 44.2005 2.2232 29.7402 -0.794022 -7.70278 -4.62871 +4589 4 44.5183 3.67066 29.3503 7.77568 15.2131 -24.9404 +4590 6 51.0808 14.1269 27.7758 -27.047 -14.2895 -4.28411 +4591 4 51.175 15.071 27.7901 8.66575 19.7266 0.878182 +4592 4 50.1173 14.0309 27.5969 15.0189 -4.76366 3.10402 +4593 6 54.1497 15.8755 27.1203 10.9044 -5.07506 15.753 +4594 4 54.6247 15.0341 27.411 -19.35 18.5916 -21.6107 +4595 4 53.6213 15.8397 26.2863 11.6919 -13.2292 13.7718 +4596 6 26.7269 15.1716 34.5247 3.07047 6.28357 -2.56105 +4597 4 26.6547 16.15 34.5201 9.87746 -16.6036 -4.19036 +4598 4 27.4477 14.9176 33.917 -5.54963 13.4877 1.89491 +4599 6 34.6713 2.21044 27.481 35.3652 -9.42756 14.1603 +4600 4 34.3712 2.0217 28.3795 -9.10436 3.38048 -0.887416 +4601 4 33.9282 2.37922 26.9258 -24.4077 6.67858 -6.22498 +4602 6 36.3012 17.6491 40.388 5.86113 23.4658 6.44349 +4603 4 35.7206 17.1804 39.7974 -3.43874 -12.7236 -2.47465 +4604 4 36.6864 17.0408 41.0377 -6.22241 -0.114851 -7.42509 +4605 6 26.2819 0.194243 33.0916 -21.1162 -1.74839 5.89968 +4606 4 26.0541 0.792538 33.818 7.17118 8.51167 2.05738 +4607 4 25.4361 41.6393 33.0097 0.772233 -7.73624 -3.23605 +4608 6 5.19547 35.5715 31.6247 14.6733 -21.492 26.4929 +4609 4 6.10271 35.831 31.8735 -9.75028 2.17691 -1.53344 +4610 4 4.97694 36.0548 30.8519 -3.41417 18.4244 -29.6169 +4611 6 20.2195 22.0294 35.119 8.25657 -3.203 11.321 +4612 4 19.9286 21.1888 34.7559 -2.68712 -4.78598 1.15285 +4613 4 20.5567 21.7901 36.0152 -5.29706 4.10974 -20.8318 +4614 6 15.9087 36.5843 36.9399 0.69981 -30.9087 31.3945 +4615 4 16.5764 37.2836 37.0377 -3.33596 -3.14632 -1.27145 +4616 4 16.032 35.9777 37.754 -5.87689 21.7482 -34.0408 +4617 6 30.95 22.3912 3.57027 12.227 -51.3484 -20.5494 +4618 4 31.0645 22.6091 4.4902 1.82476 2.59415 19.1922 +4619 4 31.2691 21.4218 3.50648 -13.7255 40.3499 2.75328 +4620 6 47.0405 8.41049 14.2025 -7.26712 -13.7585 -23.7685 +4621 4 46.2225 8.31623 13.6472 18.9804 2.55096 13.7682 +4622 4 47.7321 7.85584 13.7597 -18.0416 11.4216 8.02226 +4623 6 34.1106 18.627 3.15563 -0.4946 23.1394 22.2065 +4624 4 34.672 18.2914 3.86301 0.996255 -3.71784 -4.49801 +4625 4 34.2399 18.1173 2.36738 0.542984 -13.2578 -17.3669 +4626 6 26.7976 25.3916 12.343 -23.6037 -44.5624 17.4882 +4627 4 27.2059 26.2338 12.4335 13.1462 29.8808 4.32264 +4628 4 26.6887 24.995 13.243 7.37483 11.5945 -21.6739 +4629 6 22.6215 25.7777 30.8835 17.9212 -8.3502 11.6983 +4630 4 23.3826 25.7056 31.4928 -6.70991 6.16838 -4.71983 +4631 4 22.2455 24.8881 30.8847 -4.10822 -0.13742 -3.2228 +4632 6 23.6315 9.78689 35.7599 5.48292 -2.30097 -0.625566 +4633 4 22.8113 10.2893 35.7248 -4.77612 1.7474 -0.383276 +4634 4 23.3643 8.87406 35.5171 2.31753 16.9109 3.97959 +4635 6 10.4044 36.7742 9.63922 -25.0741 -4.1625 3.51028 +4636 4 9.48479 36.4361 9.55892 17.1497 7.1291 1.06445 +4637 4 10.7029 36.9295 8.73946 3.49181 4.27039 -8.54773 +4638 6 4.00239 32.4234 25.8687 17.3833 10.7639 11.9139 +4639 4 4.35688 32.9952 25.1699 -1.7627 -0.965582 -1.95819 +4640 4 3.3252 31.8731 25.4905 -12.2764 -14.2405 -10.2138 +4641 6 29.0717 26.0252 18.6551 27.2015 -27.7815 2.54409 +4642 4 28.1485 25.9947 18.9226 -9.28828 -8.18845 2.68073 +4643 4 29.5616 25.1801 18.9271 -24.0321 31.3207 -7.4501 +4644 6 15.3034 1.33037 27.9713 -8.15532 13.2931 -1.88459 +4645 4 14.9824 0.900448 27.1643 -4.10476 8.37726 9.18093 +4646 4 14.8435 2.19317 28.1161 8.64797 -17.4448 -9.70896 +4647 6 48.6122 2.88813 22.9601 -14.0575 20.6462 10.9468 +4648 4 48.3097 2.01316 22.7294 4.97712 -8.72373 -1.92059 +4649 4 49.4728 3.0448 22.5739 5.56154 -9.57595 -10.4155 +4650 6 53.0134 0.348391 19.7218 2.72624 -2.60203 -3.14968 +4651 4 52.5877 42.0257 20.5538 -0.625041 0.289898 3.74318 +4652 4 52.305 0.305612 19.0628 -0.905041 -0.864478 -1.55308 +4653 6 1.39118 17.4858 17.9447 -8.50794 14.6458 12.7327 +4654 4 1.24353 17.4779 16.9894 -1.31782 -10.0732 -1.96873 +4655 4 1.47925 16.6123 18.3551 -1.8326 -9.29856 -10.4725 +4656 6 37.8975 19.0277 37.6053 -28.6618 15.029 -11.7184 +4657 4 36.9647 18.7897 37.7838 11.6122 1.96204 1.16191 +4658 4 38.4406 18.4447 38.1174 10.3965 -16.3488 12.6679 +4659 6 26.9855 30.3558 38.071 9.50079 1.40194 -4.36533 +4660 4 26.0886 30.216 37.7369 5.39533 7.19535 -1.12484 +4661 4 27.2954 31.2276 37.7499 -13.0308 -11.5285 -0.168161 +4662 6 20.0885 18.5747 3.04679 -6.02291 21.5949 -15.2672 +4663 4 19.9787 17.7407 3.50085 7.53739 -11.7285 12.3408 +4664 4 20.8981 19.0299 3.33477 -4.38138 -14.9723 0.744253 +4665 6 35.0861 6.94018 4.08702 3.04221 -3.62035 -0.583554 +4666 4 35.6351 7.18342 3.33325 6.4301 -2.1748 -2.62446 +4667 4 34.2564 7.39563 3.93984 -10.6534 0.652929 2.2495 +4668 6 22.2213 37.08 31.2556 -28.1532 13.1327 42.6182 +4669 4 22.1563 36.8958 30.3458 -2.68084 -5.78815 -35.014 +4670 4 21.2899 37.3194 31.5407 35.2494 -6.03647 -12.8067 +4671 6 12.3954 22.364 41.8234 21.4337 26.9075 -8.21443 +4672 4 12.9612 23.1595 41.5956 -22.2624 -27.6618 12.5485 +4673 4 11.7092 22.295 41.1522 0.74395 2.83494 0.343647 +4674 6 43.2331 30.3213 23.157 26.8689 32.5799 1.85734 +4675 4 44.1495 30.0558 22.8796 -21.7207 5.89602 6.32158 +4676 4 43.3514 31.2801 23.4416 -6.45211 -30.9956 -6.78246 +4677 6 16.5257 8.07813 16.6617 -19.4309 -12.5216 11.6481 +4678 4 16.3886 8.34983 15.7476 7.00958 2.01583 -5.14722 +4679 4 17.4107 8.32004 16.9428 8.9294 8.4681 -2.86418 +4680 6 10.0506 8.65043 31.7756 -2.39508 10.2278 -10.4865 +4681 4 10.14 7.97578 32.4103 1.95442 -36.8206 12.1998 +4682 4 10.116 9.39125 32.3649 -0.107045 27.388 0.472024 +4683 6 10.1509 6.49695 25.6483 14.6726 -6.33183 2.00995 +4684 4 9.37694 6.15153 26.0805 -12.3653 -8.75157 5.1154 +4685 4 9.82248 7.1865 25.0601 3.70088 -0.958502 2.30736 +4686 6 49.8668 7.2369 25.5225 -24.0329 9.97804 -6.35029 +4687 4 50.053 6.31696 25.3599 8.14544 -13.6468 -2.92498 +4688 4 50.6696 7.6642 25.7982 18.0374 4.82749 5.17198 +4689 6 18.4641 37.5693 33.932 -1.74635 9.46172 -1.89257 +4690 4 17.7617 38.2474 34.0853 10.1616 -18.2299 -3.47398 +4691 4 18.0542 36.6946 34.0238 -8.30855 4.53024 1.19921 +4692 6 32.1897 34.7964 39.2558 32.2313 -17.5381 13.0656 +4693 4 32.48 34.3381 40.0896 -7.23509 10.7133 -18.5379 +4694 4 31.2879 35.0284 39.3813 -31.6037 5.0658 8.82 +4695 6 49.5304 23.9104 4.45569 25.8701 3.67026 -38.321 +4696 4 49.7808 23.1947 5.01942 4.2809 -18.8946 17.0996 +4697 4 48.8132 24.3493 4.85794 -31.8244 16.1567 21.064 +4698 6 6.0606 24.4992 33.9345 -0.638471 -2.64646 7.7036 +4699 4 6.7001 23.7849 33.7997 2.17947 5.97399 -8.00372 +4700 4 5.47521 24.1274 34.6146 -0.567039 8.82042 -5.77933 +4701 6 1.71497 22.9937 24.1827 2.23241 21.1509 -1.27791 +4702 4 1.62302 23.9425 23.95 -0.486435 -10.8617 3.92094 +4703 4 0.825214 22.7289 24.4403 -5.44701 -4.12175 2.39318 +4704 6 12.4657 16.5565 32.3481 -44.3953 42.3465 -23.9812 +4705 4 13.2256 16.0186 32.4214 25.6927 -27.9273 24.4997 +4706 4 11.8347 16.6394 33.1026 23.5286 -12.3088 -0.369419 +4707 6 21.3722 37.3857 27.9432 8.33623 1.67622 30.3175 +4708 4 21.2745 37.3852 27.0022 -8.47587 6.30229 -26.1478 +4709 4 20.7646 38.0573 28.2974 0.343549 -1.37388 -6.67046 +4710 6 27.2371 40.835 28.8059 -14.5618 2.70883 26.0148 +4711 4 26.5104 41.4636 28.9519 7.17104 -1.72995 -14.6333 +4712 4 27.2442 40.3637 29.6524 5.83721 -3.62297 -8.28664 +4713 6 0.999535 21.7321 13.5318 -29.3194 4.17708 -0.571391 +4714 4 1.85706 21.6318 13.8745 50.1621 -4.04822 5.83187 +4715 4 0.493313 21.4968 14.3164 -12.4374 2.61082 -2.41507 +4716 6 22.3196 2.57547 8.74609 19.5097 -5.43411 17.7027 +4717 4 22.9517 3.10624 8.26305 13.4452 6.72454 -0.92593 +4718 4 21.5477 2.63817 8.2102 -22.9662 -0.14239 -10.9727 +4719 6 29.9886 17.8486 8.24374 -1.93571 4.49032 -2.67939 +4720 4 29.0601 17.6146 8.32603 -5.42798 -1.41354 1.1127 +4721 4 30.4131 17.4547 9.01282 4.29332 -3.23535 5.29369 +4722 6 3.62824 37.7086 25.7053 -21.3362 8.32154 -6.60892 +4723 4 4.42904 37.184 25.8405 -4.94962 -9.47676 -0.42012 +4724 4 2.83762 37.1591 25.4673 21.6133 3.65171 5.88982 +4725 6 26.7972 27.6476 36.3581 -47.4115 -5.5291 12.7506 +4726 4 26.8465 28.2624 35.6306 8.29087 8.74477 -10.4705 +4727 4 25.8218 27.6191 36.6005 30.1762 -0.597939 -6.56813 +4728 6 13.3509 25.3111 38.1214 6.90903 -15.9492 13.2692 +4729 4 13.3459 24.3911 38.4732 0.919555 17.3618 -5.73458 +4730 4 14.144 25.7168 38.5298 -8.43807 -1.25323 -5.48633 +4731 6 49.7161 27.2636 6.73274 -18.8339 5.2299 -32.7408 +4732 4 49.5935 26.3653 6.40806 5.58405 -0.645115 8.82912 +4733 4 49.2001 27.7791 6.04852 15.3529 -4.94049 26.886 +4734 6 39.7451 11.5811 10.2076 8.75523 -9.51322 -11.6408 +4735 4 40.371 10.9447 9.80262 -5.32314 14.1891 9.76509 +4736 4 39.1233 11.799 9.49079 2.50191 2.43793 7.76023 +4737 6 17.4883 24.9894 35.5591 -19.4762 1.01983 7.35275 +4738 4 17.0975 24.7887 34.694 2.72786 0.423626 1.28381 +4739 4 18.4353 24.8575 35.5073 10.004 -2.92602 -7.93295 +4740 6 45.0832 34.9807 31.8277 24.5651 -3.79623 6.38158 +4741 4 44.3095 35.5111 32.0501 -8.6141 -4.27399 -12.5931 +4742 4 44.9123 34.3632 31.1055 -12.5508 0.508806 -0.453023 +4743 6 30.2187 9.89463 31.3271 7.05348 4.55507 6.68413 +4744 4 30.4541 10.7656 30.9635 -3.12777 -8.04008 8.45875 +4745 4 30.1355 10.0083 32.293 1.90576 1.32601 -8.54322 +4746 6 32.3712 9.2149 6.61373 28.8381 -35.7198 -39.9492 +4747 4 32.1726 8.66567 5.78496 5.01502 20.0116 29.9298 +4748 4 31.5547 9.49954 6.96481 -36.3246 12.521 14.22 +4749 6 9.26959 24.9556 35.9161 1.96832 15.842 -17.2096 +4750 4 8.91298 25.4858 35.1726 -0.127744 -15.1166 11.0351 +4751 4 9.85583 25.5957 36.3463 -2.24606 -10.0757 2.02076 +4752 6 40.3298 1.49261 18.8755 10.6299 1.30292 -21.7 +4753 4 39.6194 1.80532 19.3944 -35.8146 17.5344 12.5449 +4754 4 40.7796 0.936194 19.4956 21.1502 -18.4862 6.40423 +4755 6 5.26901 10.6323 30.4328 -1.07618 -0.575959 25.8078 +4756 4 5.0059 11.4532 29.9824 1.00544 3.53991 6.4134 +4757 4 5.36238 10.8297 31.4225 -4.75078 2.46468 -31.0333 +4758 6 25.6472 11.7043 25.6564 -2.85241 -30.912 5.54365 +4759 4 25.9319 12.4737 26.1319 5.23872 14.1859 6.15637 +4760 4 25.9893 10.9537 26.204 -5.41829 19.961 -14.7301 +4761 6 21.91 20.0664 29.7913 -6.2328 1.4725 0.460556 +4762 4 22.5319 20.0532 30.5545 -13.0709 -9.05965 -9.53591 +4763 4 21.5487 19.1817 29.5606 11.8355 8.09924 7.60661 +4764 6 10.008 19.9919 34.5046 11.2891 -12.0839 -11.2138 +4765 4 9.40296 20.4589 35.0806 -5.60052 -0.834193 8.04722 +4766 4 10.0208 19.0442 34.745 -1.06298 11.667 -2.12072 +4767 6 24.6334 10.3662 12.209 5.25257 18.8662 20.0118 +4768 4 24.6941 9.47775 12.5956 1.57271 8.96717 -2.9517 +4769 4 24.9719 11.0034 12.9045 -11.2568 -27.0384 -15.8586 +4770 6 50.4496 28.283 11.5446 48.5969 7.21476 -25.6728 +4771 4 51.3012 28.7385 11.2434 -32.0883 -19.6524 11.3949 +4772 4 50.1145 28.8771 12.2081 -10.2548 6.02908 11.3498 +4773 6 13.9159 27.6234 25.0588 -25.6331 11.4059 -15.4978 +4774 4 13.5005 28.0493 25.83 5.93925 -3.01588 -8.8098 +4775 4 13.4276 28.0022 24.2718 14.6036 -12.4854 23.8457 +4776 6 46.1589 18.6653 40.4078 -23.2184 -0.389309 -10.7846 +4777 4 45.2349 18.5626 40.0761 15.1795 0.391647 5.46432 +4778 4 46.2048 19.5984 40.6658 -0.558864 -5.77386 -4.91212 +4779 6 32.4746 14.176 27.1227 -16.003 2.1806 5.505 +4780 4 31.9042 13.6172 27.6867 7.52463 5.83279 -7.70325 +4781 4 32.1655 15.0897 27.2802 4.78128 -6.53963 -2.41902 +4782 6 14.0556 36.3553 13.3828 19.8073 6.5728 22.6139 +4783 4 14.1017 37.3298 13.5875 -14.1879 -23.5484 -13.1576 +4784 4 13.3212 36.1206 12.8052 -8.41953 14.8686 -5.40295 +4785 6 1.88392 36.5802 21.9963 -4.52806 -9.18778 1.34501 +4786 4 1.78058 36.5165 22.9531 -3.13652 -1.22736 7.08711 +4787 4 2.81062 36.8013 21.8509 3.08344 1.49572 -0.20158 +4788 6 25.283 31.8665 39.7486 -0.0346121 -4.3463 21.3102 +4789 4 24.9491 32.7147 39.4474 -1.97702 6.83441 1.95234 +4790 4 25.5262 31.9404 40.7015 -5.12155 2.92558 -20.0537 +4791 6 6.47988 22.0137 1.28428 -12.6715 -7.61279 -4.66874 +4792 4 5.53909 21.8738 1.48571 10.6555 3.73696 2.93659 +4793 4 6.5727 22.8978 0.916948 1.0061 5.37498 -0.183021 +4794 6 27.6236 25.0404 4.70626 6.00578 18.2896 15.2827 +4795 4 28.5331 25.4118 4.61276 -17.9968 -6.47987 4.19831 +4796 4 27.2352 25.3966 5.54825 13.7859 -6.49357 -18.8943 +4797 6 21.6401 30.9371 41.2305 6.69834 21.9548 -27.1087 +4798 4 21.276 30.3289 41.855 -17.7491 -18.0709 13.8774 +4799 4 21.0024 31.0127 40.4783 8.64888 -5.56942 17.5854 +4800 6 32.355 18.8729 12.7674 13.4209 4.31066 2.75957 +4801 4 31.3956 18.9706 12.835 4.55688 -5.10905 -10.5867 +4802 4 32.607 18.5493 11.8826 -7.53687 3.28724 6.30822 +4803 6 35.6452 19.4617 21.1556 -9.82604 19.2175 8.60555 +4804 4 35.3405 18.5718 21.3708 -2.26659 -3.59924 -3.4629 +4805 4 34.936 20.0876 21.4701 16.8427 -19.1907 -7.36791 +4806 6 27.6904 17.9595 34.0135 2.51947 12.848 9.8691 +4807 4 28.1207 18.371 33.2456 -3.55582 0.0466306 5.59907 +4808 4 28.0719 18.4525 34.7708 -4.77519 -7.99763 -12.3529 +4809 6 34.1913 39.0308 14.8198 -32.2909 7.81486 42.3772 +4810 4 33.7378 38.3849 14.2709 2.40292 -0.641653 -5.60016 +4811 4 33.4938 39.1934 15.5434 31.6198 -1.67931 -26.5413 +4812 6 28.5078 3.47132 33.888 -4.80695 9.04662 2.15546 +4813 4 27.9441 4.2497 33.8725 -11.1427 -2.20885 -1.07295 +4814 4 29.3801 3.85895 33.8332 18.6007 -6.2612 -1.20104 +4815 6 34.9259 32.1312 6.54177 -41.0464 -12.9808 21.9467 +4816 4 34.0171 32.0297 6.98271 38.7419 4.2921 -24.6555 +4817 4 35.5211 32.1736 7.29951 5.76537 -1.35874 -3.25655 +4818 6 31.8896 6.8799 23.5232 0.89208 3.44668 5.58958 +4819 4 32.4231 6.58347 22.7679 -0.16899 1.4285 3.8543 +4820 4 32.2407 7.75715 23.7826 1.29066 -6.24882 -6.25814 +4821 6 18.8559 1.76458 0.828337 -20.5472 23.3683 -17.7838 +4822 4 18.0266 2.11952 0.42761 13.2396 -12.575 3.84382 +4823 4 19.0445 2.38904 1.53279 3.18086 -1.81057 9.578 +4824 6 26.9929 18.9294 11.856 68.8676 -4.65359 -28.5611 +4825 4 27.3133 19.7685 11.4551 -15.5879 -7.28987 7.59546 +4826 4 26.1136 18.988 12.1267 -55.7646 13.8464 15.3945 +4827 6 43.8351 11.1458 18.4443 23.0031 -19.5153 4.50837 +4828 4 43.638 10.8812 17.5537 -13.1544 4.18059 -17.1583 +4829 4 44.5589 10.5175 18.6246 -1.75483 13.9327 9.72942 +4830 6 33.4946 40.5615 37.6755 15.4013 8.76106 -9.33396 +4831 4 34.0096 40.2689 38.4502 -12.4229 -1.46966 -1.83753 +4832 4 32.5786 40.2698 37.7667 -1.95229 -4.85928 9.55413 +4833 6 15.6186 26.7023 39.419 -29.2453 -49.1617 7.39509 +4834 4 15.4971 26.9949 40.3155 1.17426 12.5786 14.7177 +4835 4 16.1446 27.3092 38.9602 29.5915 33.502 -22.8309 +4836 6 4.38071 13.8775 40.883 9.27553 -14.126 -4.37485 +4837 4 5.31782 13.6454 41.0342 -11.8393 4.50398 0.960258 +4838 4 4.04834 13.2497 40.2173 2.13772 10.7877 7.68198 +4839 6 20.1656 10.4005 38.218 10.8779 4.82467 -13.4554 +4840 4 20.4848 10.7245 37.3555 -10.2589 -5.36296 0.708096 +4841 4 20.9923 10.2607 38.6798 -1.28838 -2.71386 11.844 +4842 6 15.1666 19.24 23.8849 4.49083 -8.21488 3.46045 +4843 4 15.3253 20.1347 24.2296 -1.0797 -1.90309 -4.08137 +4844 4 15.0239 19.3391 22.9299 0.969961 5.53483 11.956 +4845 6 47.8934 28.614 15.7995 12.3109 16.1315 8.54118 +4846 4 47.9523 27.7003 15.5425 0.10403 -15.196 -3.00888 +4847 4 48.6265 28.752 16.4246 -6.57835 -5.21115 -6.70139 +4848 6 29.9259 30.9075 18.965 7.62461 4.23841 -1.37457 +4849 4 29.1117 30.4308 18.7732 -7.06282 -5.88302 -2.4339 +4850 4 29.7134 31.8391 18.8515 -2.57834 1.4724 1.74445 +4851 6 11.9338 35.8178 28.497 -7.27451 6.14295 -10.3733 +4852 4 12.5041 35.9802 29.2427 6.70347 11.4983 16.16 +4853 4 12.1847 34.9375 28.2428 -3.53576 -18.0038 -9.26428 +4854 6 29.972 37.8772 25.486 -12.1052 4.73031 -22.3992 +4855 4 30.2553 36.9663 25.6711 3.40868 8.54106 4.83275 +4856 4 30.3747 38.5051 26.0898 8.03536 -1.45294 10.6494 +4857 6 52.6584 28.1048 32.275 31.4311 4.91254 4.04956 +4858 4 52.2473 28.8547 31.8392 -9.38068 2.35947 -3.12986 +4859 4 53.5924 28.4001 32.3224 -6.05351 -9.99886 1.81474 +4860 6 37.0156 40.0823 11.982 15.2095 -8.99172 -8.52195 +4861 4 36.22 40.5624 12.1833 -15.2617 4.79593 6.40041 +4862 4 37.4101 39.8767 12.8402 0.665617 -0.484924 4.09883 +4863 6 16.6662 16.7824 36.4899 -23.6543 20.4081 -13.3107 +4864 4 16.0299 17.4889 36.7962 20.061 -22.8424 -10.9222 +4865 4 16.728 16.9177 35.5139 -3.3638 -0.555369 18.7216 +4866 6 27.9984 4.17668 38.8431 -6.8633 -1.77316 4.22536 +4867 4 28.9161 4.3061 39.1095 4.06977 1.67187 2.70396 +4868 4 28.0368 3.69267 38.0106 -3.95018 -5.40445 -5.6405 +4869 6 28.9057 0.266004 17.7212 -6.10073 29.2375 -5.44551 +4870 4 28.1786 0.88303 17.5246 8.92385 1.95552 -1.67076 +4871 4 28.4447 41.3635 17.8399 -11.0591 -30.1495 5.35559 +4872 6 22.9291 20.1009 26.2737 12.905 2.01461 18.3128 +4873 4 23.6265 20.0378 26.9508 -1.05622 -6.52034 -10.1156 +4874 4 22.4706 20.8929 26.5742 -3.00423 3.39878 -4.61403 +4875 6 49.3993 29.9017 13.433 -6.38025 27.1117 -0.919919 +4876 4 49.1201 30.8275 13.1802 1.84527 -26.9682 8.98406 +4877 4 48.7504 29.5045 14.041 1.51099 8.43883 -0.914593 +4878 6 2.44855 24.8301 7.30401 -10.5471 2.4163 20.698 +4879 4 2.41495 24.6588 8.2845 -1.1432 9.4633 -23.8545 +4880 4 1.72338 25.455 7.1058 6.30785 -9.44609 7.39061 +4881 6 30.3915 26.4508 14.3344 -6.38639 41.9339 41.7386 +4882 4 31.0669 26.3804 15.0403 -0.162406 -14.5956 -15.076 +4883 4 29.932 27.2875 14.6522 8.5071 -34.3491 -22.1885 +4884 6 27.0361 32.5047 3.13805 -13.013 14.5566 5.91638 +4885 4 26.4776 33.1542 3.63465 13.8957 -14.3888 -12.6314 +4886 4 27.3381 31.8882 3.81715 0.997102 -1.94867 -0.811892 +4887 6 34.2693 14.8073 1.28197 14.9869 -24.9335 -24.2287 +4888 4 35.1732 14.4308 1.1613 -12.3133 12.1546 9.27146 +4889 4 33.7818 14.2606 0.617478 5.51233 18.0169 18.4334 +4890 6 30.0243 8.54272 1.33127 -15.3984 1.11418 15.9731 +4891 4 29.9557 9.47917 1.12547 1.89625 5.05184 -1.94546 +4892 4 29.278 8.4251 1.95594 13.4411 -5.55834 -8.66406 +4893 6 42.5535 11.5155 27.7085 15.437 -3.44919 -13.726 +4894 4 42.3225 12.4337 27.8881 -6.79772 -1.02898 5.45325 +4895 4 41.899 10.9203 28.077 -14.0379 1.06089 7.70623 +4896 6 52.4658 39.5603 17.8381 6.64956 -28.6351 -32.0971 +4897 4 51.7413 39.7621 18.3991 -22.9429 13.2738 25.1291 +4898 4 53.1708 40.1592 17.9962 19.9289 22.995 10.0024 +4899 6 33.211 4.92827 31.629 -12.2211 32.167 9.39859 +4900 4 32.8163 5.83971 31.6275 7.84415 -21.2817 2.59476 +4901 4 32.9135 4.52627 30.8083 -0.68235 -2.18314 -5.10952 +4902 6 6.29493 15.9859 18.7482 13.6791 10.985 9.78561 +4903 4 5.93033 16.6016 19.4273 2.88753 -17.718 -13.1605 +4904 4 5.60754 15.3724 18.4768 -10.6912 0.909102 4.08099 +4905 6 8.51749 14.5386 24.6879 -5.02573 1.07483 -2.93277 +4906 4 9.38168 14.4087 25.0828 4.4136 1.3116 3.34168 +4907 4 8.20169 13.6557 24.4566 1.37146 0.850768 1.15416 +4908 6 22.6856 10.1159 32.1347 3.63858 -5.5341 -7.29103 +4909 4 22.4401 11.0127 32.2731 -27.0162 20.0988 15.0061 +4910 4 23.4682 10.3148 31.6383 25.2173 -15.197 -13.8617 +4911 6 11.2884 2.11431 14.6724 -33.0968 -7.95794 -19.898 +4912 4 10.3134 2.08073 14.4479 21.8664 -1.34414 10.3974 +4913 4 11.7152 2.30811 13.8211 9.70644 2.30495 0.939267 +4914 6 44.9099 15.5878 36.2745 25.7257 2.41581 -13.4012 +4915 4 45.0546 15.5553 35.3019 -10.2235 2.9059 20.3658 +4916 4 43.9848 15.4747 36.4307 -17.7944 -2.84066 -0.111047 +4917 6 9.72168 19.0116 31.2214 10.0341 -21.2505 -12.9994 +4918 4 10.5925 19.389 31.3727 0.996524 0.534629 3.32861 +4919 4 9.08651 19.5363 31.6795 -15.0033 12.5653 12.9482 +4920 6 51.9861 7.59179 16.6767 -2.21949 13.5197 0.492591 +4921 4 52.6037 6.8327 16.6765 -16.3843 6.63384 -16.8766 +4922 4 51.5083 7.75362 15.8118 21.6515 -16.4571 17.7861 +4923 6 31.4364 34.7816 36.4086 3.08769 21.0155 -3.2672 +4924 4 31.7704 34.8477 37.2975 8.82098 -13.2304 13.8104 +4925 4 31.3443 35.7177 36.1951 -3.32863 3.82124 -15.3061 +4926 6 4.22848 15.0876 15.3675 -15.1793 -4.71932 15.5862 +4927 4 4.10446 14.9036 16.3273 5.02277 2.80423 -15.2934 +4928 4 5.16622 15.2495 15.2447 10.6913 1.67801 0.337818 +4929 6 47.7535 20.6847 28.0297 3.73811 3.24498 -1.95167 +4930 4 47.6703 19.7739 27.6852 3.21079 12.9013 3.0329 +4931 4 48.3469 21.1738 27.4217 -9.1514 -8.95746 6.26441 +4932 6 15.7983 1.14885 24.4111 -6.64534 16.957 -16.446 +4933 4 15.3695 0.397874 24.8496 -11.2605 5.13601 -9.62176 +4934 4 15.1572 1.72115 23.8957 14.1067 -25.56 23.4483 +4935 6 34.5718 39.7067 40.0668 -5.06722 14.7699 1.92827 +4936 4 34.1159 40.1215 40.7935 -0.0189783 27.8984 7.01187 +4937 4 34.2456 38.8495 40.221 -5.22714 -44.7262 -10.8544 +4938 6 20.1936 32.176 34.4055 -22.5016 27.7868 41.3602 +4939 4 19.6673 32.7687 35.0502 14.2298 -29.0143 -30.198 +4940 4 21.0584 32.1328 34.8407 -2.28869 -2.39527 -4.5293 +4941 6 19.3074 38.5208 11.8317 17.689 14.4135 -2.63233 +4942 4 19.236 37.5914 12.0232 -0.177798 -10.0936 4.99209 +4943 4 20.0172 38.8749 12.4245 -13.7536 -7.85063 -8.99287 +4944 6 6.52955 13.5023 26.836 -16.6143 37.6784 -17.6139 +4945 4 6.084 14.0762 26.1427 18.8957 -21.2062 24.9102 +4946 4 6.49663 12.6281 26.4634 0.197125 -15.4908 -4.14034 +4947 6 23.5952 31.5638 33.3318 1.16311 -12.5666 -5.83621 +4948 4 23.0836 31.562 34.1475 0.610672 3.97154 0.891929 +4949 4 23.5328 30.6432 33.0053 1.46337 8.27478 -1.79938 +4950 6 41.0778 31.9114 16.1974 16.3032 -14.6541 -18.8682 +4951 4 41.8878 32.072 16.7344 -12.1593 -9.44827 -16.6375 +4952 4 41.2894 31.3264 15.4036 6.53327 16.9697 25.199 +4953 6 31.7476 18.8699 19.3483 9.2825 22.1595 5.37598 +4954 4 32.0642 19.7361 19.7036 -9.20895 -19.367 -8.68372 +4955 4 31.4026 18.3831 20.1168 1.10858 -0.37958 -4.48043 +4956 6 10.4875 4.12209 19.3444 6.70816 11.4672 -10.0773 +4957 4 9.70261 4.48263 18.8666 20.7562 -4.21822 -0.723312 +4958 4 11.3166 4.33216 18.8218 -27.5212 -3.06207 15.0001 +4959 6 1.37991 32.4635 19.2846 24.7257 -29.6508 -15.3303 +4960 4 1.97113 31.6954 19.1311 -3.90248 7.07021 19.3035 +4961 4 1.16609 32.6455 18.3731 -9.24935 13.5936 -9.63824 +4962 6 42.8716 16.8513 24.9892 37.8526 -21.8211 -51.5646 +4963 4 42.4398 17.6894 25.0051 -12.6784 17.6471 3.13223 +4964 4 43.4179 16.871 24.1222 -26.4831 0.994324 39.976 +4965 6 45.3183 19.1979 4.10041 6.37956 15.045 3.35342 +4966 4 46.1127 19.7887 4.04575 -15.2131 -7.48775 2.85843 +4967 4 44.6191 19.6898 4.58798 10.0124 -1.75765 -5.61527 +4968 6 29.1291 19.8804 35.7574 13.154 -41.1853 -12.3735 +4969 4 28.6049 20.2559 36.4387 -19.4183 16.2678 16.1743 +4970 4 29.3151 20.5439 35.0927 -1.78114 11.3903 -2.63997 +4971 6 31.9353 21.8377 19.6787 8.2762 14.7684 -3.54893 +4972 4 32.7301 21.8918 19.0885 -22.5823 -4.29925 15.9785 +4973 4 31.6692 22.7774 19.8195 3.83825 -20.8185 -1.08359 +4974 6 39.1936 8.26228 18.8336 -23.7578 16.4079 -2.4793 +4975 4 38.9784 7.343 18.63 -1.41923 -3.63173 -0.882922 +4976 4 38.3593 8.77699 18.6285 24.7505 -17.6369 4.60834 +4977 6 33.27 13.2649 41.2621 -10.1289 -28.0457 11.6457 +4978 4 32.3532 13.5818 41.1472 2.43324 -1.71459 -0.314725 +4979 4 33.2053 12.355 41.6729 1.3348 20.3333 -9.56947 +4980 6 5.93721 29.5458 35.7995 -7.4397 -15.3695 -5.23966 +4981 4 6.3797 30.3135 36.1022 6.42857 23.5026 12.0451 +4982 4 6.51225 29.246 35.0987 1.02237 -6.8727 -9.18458 +4983 6 13.023 34.1764 31.9266 -10.1581 -4.84889 27.419 +4984 4 13.003 33.3874 31.3637 -4.82745 -5.23795 6.11925 +4985 4 12.6053 33.9771 32.8123 10.4055 -1.49763 -26.3146 +4986 6 33.9757 21.8032 17.9969 16.1152 -19.1834 -4.43927 +4987 4 34.6651 21.0941 18.0436 -13.0194 10.1005 -1.31384 +4988 4 34.4424 22.6001 17.7557 11.611 10.6919 -5.33679 +4989 6 35.9777 41.3398 18.1614 -6.56463 -6.11943 -26.9477 +4990 4 35.8856 41.423 17.1648 6.35377 -3.40276 32.4743 +4991 4 36.5823 0.128109 18.4064 3.22136 6.47441 1.04719 +4992 6 34.856 37.6452 30.5972 -0.647303 3.94572 7.36538 +4993 4 35.2577 36.9607 30.0196 0.445186 1.06156 15.4535 +4994 4 34.8848 37.3986 31.5588 5.49281 -5.52744 -23.9922 +4995 6 25.9972 34.4216 4.68589 -10.7784 -9.94602 -21.2075 +4996 4 25.3582 34.53 5.39473 2.66172 5.48603 12.8385 +4997 4 26.8259 34.8497 4.89674 4.47855 8.12742 13.9663 +4998 6 19.0606 33.5662 1.31783 4.31184 23.0948 -29.5486 +4999 4 19.7493 33.0549 1.74461 7.17592 -5.61608 3.87291 +5000 4 19.5019 34.1007 0.592753 -8.94353 -18.7796 23.9626 +5001 6 25.2721 8.22916 8.60038 8.3672 -6.50911 13.4278 +5002 4 25.4774 8.1828 9.55838 -2.37789 7.03817 -10.0574 +5003 4 25.4001 9.14285 8.30246 -0.229164 -0.61302 1.82749 +5004 6 12.8408 19.6874 13.0432 23.1779 -10.767 -3.57874 +5005 4 11.9236 19.9359 13.0109 -16.1394 8.08564 -1.3752 +5006 4 13.3549 20.4875 12.8299 -11.6819 -5.55115 1.76181 +5007 6 53.3458 11.4322 5.81729 13.7919 -26.0181 10.511 +5008 4 53.941 11.999 6.3288 -5.2171 7.54934 -1.97002 +5009 4 52.6156 11.905 5.44666 -11.025 16.6744 -4.72885 +5010 6 9.84401 16.0447 31.1965 1.52473 25.7097 1.4485 +5011 4 9.0725 15.75 30.7245 -12.2986 -10.5074 -10.4763 +5012 4 9.76401 17.0228 31.1974 4.09395 -10.8484 3.46066 +5013 6 25.4337 20.2897 3.31222 -0.0744965 -16.6885 15.2888 +5014 4 25.4502 20.7681 4.1742 1.29774 3.58896 -22.0188 +5015 4 25.617 20.9088 2.59036 0.892976 4.59184 10.0233 +5016 6 20.7687 8.19442 15.6442 -13.8219 -45.5838 -0.24202 +5017 4 20.3131 8.5145 16.4113 -6.16339 18.6345 13.1662 +5018 4 20.3525 7.29833 15.5772 17.5129 18.5489 -8.91575 +5019 6 37.6537 8.61162 9.99803 6.38032 -10.5281 17.8344 +5020 4 37.9174 7.70722 10.2264 -2.01487 8.44182 4.78342 +5021 4 37.3414 8.51532 9.10193 -3.86116 3.7435 -6.65528 +5022 6 50.6588 4.51187 24.2729 -10.1552 -3.70856 6.87258 +5023 4 49.9071 3.88527 24.1971 13.583 4.61791 0.248303 +5024 4 51.4381 4.036 24.5943 -3.42543 -3.47462 2.6777 +5025 6 20.1632 24.8244 34.8962 -12.0105 28.899 -22.2545 +5026 4 19.9486 25.4522 34.1467 5.29317 -18.0262 19.0072 +5027 4 20.331 23.9626 34.5117 -0.31696 -10.3492 -2.27521 +5028 6 30.5785 22.522 11.2467 -2.76969 13.8933 23.9619 +5029 4 31.2526 22.1243 10.7257 13.2932 -13.8734 -17.1472 +5030 4 31.019 23.338 11.5119 -11.6942 5.7798 2.38886 +5031 6 17.322 40.803 8.03266 14.2969 -15.2802 9.14469 +5032 4 17.3696 39.9923 8.55945 -20.3131 5.85274 7.92005 +5033 4 18.1352 40.6655 7.5489 4.4024 9.10004 -19.1526 +5034 6 23.9661 41.0457 26.0803 21.1205 -0.428792 10.5169 +5035 4 24.3123 40.6207 25.2948 17.4674 -5.32369 -4.96192 +5036 4 23.0464 41.0448 25.8953 -36.0489 4.67224 4.09659 +5037 6 9.79449 25.5813 27.216 11.7002 -20.4303 -20.1428 +5038 4 10.1564 25.0129 26.491 -8.57195 17.3601 17.171 +5039 4 10.1924 25.2359 28.0288 -3.53182 0.239058 0.558234 +5040 6 35.2535 29.8267 24.7533 16.8399 6.514 6.92542 +5041 4 34.3962 29.6585 24.3475 -6.29365 6.70405 -5.90439 +5042 4 35.51 30.7547 24.57 -10.2352 -8.20594 -2.77553 +5043 6 2.14051 4.25227 10.5512 -4.35014 2.09559 7.87868 +5044 4 1.87018 4.24401 11.51 4.03105 2.56783 -22.6964 +5045 4 1.48695 4.75313 10.0317 0.0426026 -1.98947 12.7879 +5046 6 43.1755 3.92129 23.5016 -16.6861 -14.9885 0.818311 +5047 4 43.8939 4.14262 22.9078 7.68421 2.83398 -7.81803 +5048 4 42.5577 3.34913 22.9937 11.3891 7.34243 2.48813 +5049 6 18.8996 22.6297 2.43765 22.7339 -13.1014 -2.24121 +5050 4 19.79 22.181 2.40524 -25.7911 11.1615 4.63986 +5051 4 18.7139 22.8085 3.37028 4.18935 -2.21949 -1.21374 +5052 6 20.4908 18.9405 41.5599 0.284845 -17.4141 21.8797 +5053 4 20.1374 18.6064 0.533469 2.69626 22.1818 -33.2143 +5054 4 19.9839 19.6587 41.147 -4.56676 -6.01516 12.1125 +5055 6 26.4163 7.55623 29.1338 1.47231 -3.25042 -11.8229 +5056 4 25.7099 7.08251 28.6481 8.40182 7.03804 13.9135 +5057 4 27.0821 7.71224 28.4448 -4.02075 -2.1597 11.7889 +5058 6 25.6465 35.5679 33.7595 -11.9902 -19.4032 2.16293 +5059 4 26.3374 36.2384 33.6103 2.60319 -14.9989 -6.30077 +5060 4 25.8315 34.6987 33.2841 2.54327 33.8846 12.2934 +5061 6 24.8333 0.493635 8.41989 34.5336 11.5552 47.2955 +5062 4 25.5249 0.302877 9.1499 -35.8013 6.01564 -39.2036 +5063 4 24.7614 41.6068 7.91956 0.436288 -16.6888 -13.1367 +5064 6 17.008 17.3182 3.45493 -26.2706 15.7324 15.4846 +5065 4 16.2426 17.9829 3.53843 29.8189 -30.5055 4.13684 +5066 4 17.1653 16.9244 4.35506 -11.2277 16.1793 -19.3505 +5067 6 40.1827 32.1035 19.3506 13.0539 -5.95213 0.358733 +5068 4 39.8335 31.2604 19.604 -25.4023 -11.2285 12.0125 +5069 4 40.9513 31.7409 18.9215 18.5667 14.352 -9.19942 +5070 6 23.3808 26.7171 6.31746 29.0762 21.4976 14.3842 +5071 4 24.13 27.3908 6.46801 -30.1018 -19.5893 -7.69607 +5072 4 22.7349 27.0723 5.68536 3.11778 6.18165 -0.6273 +5073 6 28.6527 28.5112 1.41186 -10.6623 -30.4119 4.69741 +5074 4 28.683 29.4458 1.20631 15.125 4.74584 -7.70298 +5075 4 29.5288 28.0803 1.2704 -12.115 26.7011 1.44139 +5076 6 12.0438 6.3157 14.0384 -8.70244 -3.06108 -4.52058 +5077 4 11.2798 6.1721 13.4181 27.4537 -0.215786 8.28745 +5078 4 12.8925 6.19521 13.5554 -16.057 2.9292 1.41242 +5079 6 20.1243 33.7022 32.0954 -30.4257 7.53408 -8.19993 +5080 4 20.1371 33.1054 32.8412 7.6416 -5.80656 10.7415 +5081 4 21.0197 33.8732 31.8382 18.9224 -1.8204 -0.321518 +5082 6 12.0625 33.3632 34.5388 -0.325915 -41.4281 -23.9157 +5083 4 11.5602 33.8727 35.1697 -10.674 0.646784 10.687 +5084 4 11.6234 32.4653 34.3673 14.5179 34.5198 8.14895 +5085 6 6.00279 22.2605 25.0501 2.06163 -11.5991 79.3474 +5086 4 5.88194 22.3996 24.153 -16.4068 14.8809 -57.8418 +5087 4 5.25089 22.6367 25.5854 16.5977 -6.05374 -22.2773 +5088 6 28.8802 9.48792 11.0269 30.0757 -27.8021 5.60101 +5089 4 29.142 10.167 11.6644 -15.2392 1.2069 -12.766 +5090 4 28.0854 9.70897 10.5587 -15.7703 15.13 -3.00542 +5091 6 25.9783 31.1564 24.8742 0.212243 -23.2246 11.0271 +5092 4 26.2703 31.9474 24.4305 5.78101 9.73635 -10.8861 +5093 4 26.5948 30.4205 24.6499 -9.08002 14.2421 1.82694 +5094 6 17.4069 22.6321 26.9528 -11.8732 29.0046 13.506 +5095 4 17.1509 23.4374 27.5137 11.798 -28.7792 -23.9739 +5096 4 17.5283 21.9112 27.5803 0.671776 -8.09241 2.21186 +5097 6 30.9731 17.6144 1.64569 13.582 26.8251 31.1357 +5098 4 30.2123 17.6859 1.07719 -13.0538 -2.75682 -13.3747 +5099 4 31.0067 18.4528 2.19078 1.05257 -25.2161 -14.5596 +5100 6 35.2833 9.73343 11.2271 -16.277 -4.62114 -26.0747 +5101 4 34.627 9.45499 10.5137 29.3374 5.62349 25.4867 +5102 4 36.1567 9.37366 10.9701 -6.28276 0.375521 -3.01301 +5103 6 12.0057 10.8077 4.27601 -12.2512 -1.40581 -7.43609 +5104 4 11.4458 10.5898 5.05281 2.39288 0.24657 -15.6405 +5105 4 11.51 10.5288 3.46435 7.55978 2.35404 20.8087 +5106 6 52.9546 23.1284 7.66438 3.19212 11.9041 -9.13647 +5107 4 53.8155 23.0936 7.22037 1.72331 -6.21969 -0.472682 +5108 4 52.7997 24.0739 7.82392 -0.633169 -8.94194 3.43433 +5109 6 27.374 5.80114 23.1096 7.51778 12.7335 11.6917 +5110 4 28.1753 5.52132 23.6349 -22.415 18.9583 -13.4562 +5111 4 27.3645 6.79042 22.9959 5.3793 -33.2455 5.89418 +5112 6 22.7689 37.6996 15.5372 -5.91943 -7.67105 33.7333 +5113 4 22.8436 37.842 14.6084 2.14719 5.97904 -25.5056 +5114 4 23.2999 36.9284 15.7907 -0.822855 1.46565 -2.93441 +5115 6 30.5901 30.1355 39.7465 -8.92084 9.99629 -19.6672 +5116 4 30.0839 29.6315 39.0953 -1.54922 -9.94816 6.16305 +5117 4 30.5761 31.0154 39.3281 8.00114 -4.73058 9.29019 +5118 6 26.5152 14.8694 29.9646 3.93344 -0.205179 -3.29595 +5119 4 25.7559 15.3094 30.3103 -24.5604 12.1261 -1.41502 +5120 4 27.0839 14.9289 30.718 22.1413 -5.57177 12.178 +5121 6 9.52543 19.5487 37.4182 -4.93509 -3.75546 7.04348 +5122 4 8.56858 19.5373 37.6772 20.7537 10.8584 -9.00922 +5123 4 9.7741 20.4052 37.0166 -14.5013 -9.56436 9.93265 +5124 6 0.91928 14.8658 2.69601 -17.5095 9.99019 63.3715 +5125 4 1.47581 15.1737 2.02419 28.2707 8.36374 -43.6031 +5126 4 1.18821 15.4309 3.47389 -7.04008 -21.0896 -18.5042 +5127 6 46.427 27.1287 41.5945 43.2461 -1.33556 -25.8044 +5128 4 47.402 27.2052 41.2817 -46.4011 -2.64418 15.4668 +5129 4 46.0299 26.5803 40.8989 0.996959 5.24299 8.87294 +5130 6 47.678 23.0562 21.3872 5.44089 38.3346 6.01366 +5131 4 46.9403 23.2179 20.8133 -13.997 9.90145 -6.64011 +5132 4 47.7418 22.1285 21.385 8.56341 -43.7487 4.99103 +5133 6 39.8587 22.235 3.08723 2.37939 -15.5871 -9.21378 +5134 4 39.0088 22.2526 3.53641 -4.44104 7.43329 4.08383 +5135 4 39.9535 21.2857 2.86173 -0.917299 22.2801 6.61021 +5136 6 14.9853 14.9328 33.4647 9.90785 18.6887 5.96998 +5137 4 15.4024 15.8269 33.5858 -13.0369 -24.3412 -0.758701 +5138 4 14.5599 14.6915 34.3048 3.28451 6.61064 -6.43534 +5139 6 27.3302 11.4834 31.9317 -27.4366 -15.9755 21.8219 +5140 4 26.9982 12.0952 32.5883 -9.79098 -5.70708 8.51591 +5141 4 28.0752 11.9422 31.6406 46.9031 18.536 -28.2392 +5142 6 36.7579 7.97089 7.62034 -1.24967 -18.9477 -14.6485 +5143 4 35.954 7.42009 7.70022 6.4697 6.94413 -3.0671 +5144 4 37.4142 7.36122 7.22008 -3.07725 6.9494 1.66736 +5145 6 49.4451 9.66335 18.2174 -4.20907 -17.0946 -5.32386 +5146 4 50.1075 10.0642 17.6138 -11.2883 10.4151 20.0604 +5147 4 49.0937 10.2089 18.9473 16.8995 10.9543 -13.1485 +5148 6 27.0353 33.866 10.7555 -3.61813 20.4819 39.0174 +5149 4 27.1089 33.3944 9.9425 -11.0368 -7.55411 -28.9907 +5150 4 26.1735 34.332 10.8422 4.28798 -12.7598 -13.2634 +5151 6 11.1949 37.4624 6.84871 0.36549 -16.8746 15.3404 +5152 4 10.8648 38.3395 6.66289 0.465253 11.7734 -2.90488 +5153 4 12.1583 37.5341 6.85599 1.64848 0.115814 -1.2743 +5154 6 19.2537 19.4156 21.9114 -15.7985 8.22585 33.6704 +5155 4 18.5515 19.3251 21.2863 -16.3583 -5.26309 -15.3133 +5156 4 20.0646 19.323 21.4355 25.7859 -3.53787 -14.4318 +5157 6 54.4972 2.91444 22.5674 41.6328 11.7794 25.4635 +5158 4 54.323 3.09449 21.6644 -16.7292 4.15243 -34.296 +5159 4 0.405558 3.31869 22.7045 -24.6299 -12.807 4.19326 +5160 6 45.0583 10.8549 24.2301 5.83399 20.0221 21.0618 +5161 4 44.4296 11.5751 24.1426 -7.03973 -3.51443 -9.4179 +5162 4 45.6095 11.2138 24.9523 4.1225 -19.1196 -10.3672 +5163 6 14.387 34.402 24.7643 -0.614961 -5.50567 -8.46915 +5164 4 14.802 35.2302 25.0278 -0.621724 2.17228 4.67692 +5165 4 14.8142 34.1913 23.9221 -0.527667 -3.77388 -2.27373 +5166 6 50.586 17.557 4.30707 17.1275 -18.9627 18.6811 +5167 4 51.3126 17.9927 4.759 8.45418 -3.82203 7.11351 +5168 4 50.1863 18.2804 3.88376 -26.598 27.5468 -24.7799 +5169 6 14.9317 33.3337 34.1113 -12.3404 20.8418 56.9019 +5170 4 15.0455 32.9404 33.2912 5.44957 -23.8922 -53.334 +5171 4 14.0148 33.1563 34.3942 8.12215 6.97131 -5.23034 +5172 6 20.8706 33.5768 38.9143 15.1188 7.04694 -15.6549 +5173 4 20.7999 34.008 39.7578 -2.44584 7.66125 17.1111 +5174 4 20.3826 32.7659 38.9944 -10.1095 -18.4284 -0.973943 +5175 6 7.78494 4.73961 26.7587 18.7098 -5.63937 13.378 +5176 4 7.2181 5.0845 27.4506 -5.7435 6.37459 2.19378 +5177 4 7.246 4.75931 25.9687 -5.82922 -1.99593 -5.70414 +5178 6 9.28281 21.4851 22.3014 51.087 14.0475 -25.6174 +5179 4 8.74732 21.9732 21.6886 -31.0609 5.1079 -5.58489 +5180 4 10.1706 21.7227 21.8793 -22.1752 -18.3044 28.8298 +5181 6 20.5441 38.2146 8.8638 -2.83914 11.917 26.817 +5182 4 20.3663 38.6401 9.7626 4.81036 -21.6973 -30.7816 +5183 4 20.4013 37.2533 8.94236 -1.07384 9.24152 7.62946 +5184 6 30.1053 39.0795 30.7451 -13.6764 41.2724 28.6819 +5185 4 30.3998 39.946 31.2193 -9.10868 -42.8123 -24.766 +5186 4 29.1169 39.0706 30.8728 28.3121 -0.882933 -5.94109 +5187 6 16.0486 22.0268 24.5039 34.2787 3.60452 0.906339 +5188 4 16.7735 22.0671 23.8432 -14.3833 -3.87047 -0.289875 +5189 4 16.5419 22.3002 25.3044 -14.2176 -3.36187 3.5873 +5190 6 5.74232 29.2062 14.4594 -18.34 10.8061 -32.1404 +5191 4 6.48422 28.7094 14.7814 11.5218 -3.49899 17.506 +5192 4 5.24211 29.6259 15.1721 5.10135 -5.91064 9.04276 +5193 6 28.0673 3.08827 25.2267 -6.08854 1.42804 12.0746 +5194 4 28.6661 3.71086 24.7756 -7.19123 -0.840207 10.3279 +5195 4 27.7106 3.5203 26.0449 13.0908 -0.523763 -20.3567 +5196 6 45.9319 29.2971 31.4223 -7.33073 21.7818 28.5056 +5197 4 45.7264 28.738 30.6765 -12.0419 -4.51403 -16.7723 +5198 4 45.1872 29.9464 31.611 20.2512 -24.9239 -13.0948 +5199 6 11.2178 22.8398 36.7928 3.83605 7.6889 -19.1741 +5200 4 10.7288 23.4227 36.1801 1.54849 -6.36416 6.79315 +5201 4 12.0227 22.5824 36.3 -5.92076 -0.954096 11.0422 +5202 6 18.9236 40.1387 39.9284 -8.72712 -15.4473 12.674 +5203 4 19.137 39.1923 39.9727 -1.01676 1.76774 -7.47997 +5204 4 18.926 40.4024 40.8597 -1.95632 5.76083 -1.10583 +5205 6 23.5567 26.0801 21.2876 -20.8354 -5.58511 20.4095 +5206 4 22.8283 26.6117 20.9473 7.44123 1.31497 -7.03875 +5207 4 23.1869 25.6705 22.0991 12.7429 3.57595 -14.6326 +5208 6 16.8309 5.38685 15.8596 17.5735 -24.6285 20.3591 +5209 4 16.4468 5.29371 14.9868 -10.6119 14.9975 -0.930521 +5210 4 16.6163 6.1995 16.3389 -7.69088 7.65746 -13.895 +5211 6 12.049 26.6129 14.9962 1.83385 5.07399 -16.0821 +5212 4 11.6864 25.936 15.5307 6.55853 -24.3886 27.1256 +5213 4 11.2609 26.839 14.5085 -0.894459 16.8406 -16.785 +5214 6 14.3334 41.4222 2.37421 26.0216 21.5484 -18.2857 +5215 4 13.7051 40.9662 2.90199 -22.7144 -12.1023 21.977 +5216 4 14.3738 0.426145 2.71152 -4.41702 -11.6567 2.07407 +5217 6 50.4009 35.8582 9.31454 24.1561 17.2373 -12.1424 +5218 4 50.8168 35.8748 8.42953 -10.1576 -5.67977 3.83986 +5219 4 50.8977 36.5714 9.7704 -11.7974 -14.2445 3.10197 +5220 6 11.3695 22.6672 26.8678 6.20997 3.92483 11.2558 +5221 4 12.2048 22.3333 26.5164 -4.88328 -1.76893 -0.685046 +5222 4 10.6892 22.391 26.2565 -8.40373 -4.36232 -8.95219 +5223 6 8.45148 34.5593 21.2814 -25.9919 -59.0281 13.1791 +5224 4 8.04792 35.0446 21.9998 -0.548909 12.0582 7.93151 +5225 4 8.02348 33.6171 21.3881 27.3669 48.26 -12.6189 +5226 6 9.41918 8.68911 24.4735 -32.1109 22.232 -11.1027 +5227 4 8.45415 8.80658 24.2608 22.5553 -3.45738 3.03744 +5228 4 9.54271 9.26889 25.2379 6.1219 4.18012 4.13063 +5229 6 32.6166 22.3351 34.507 3.90791 9.0503 -27.7323 +5230 4 32.5036 23.1955 34.0662 0.599489 -5.17288 -1.28756 +5231 4 32.8196 22.6091 35.3861 6.87298 3.84758 30.2519 +5232 6 26.7427 26.1702 7.11338 18.0622 8.0778 -11.4877 +5233 4 26.0574 25.7087 7.60312 -9.51312 -3.43645 7.19196 +5234 4 26.4504 27.0916 6.97179 -2.60416 -16.0173 4.37043 +5235 6 33.9976 11.9299 3.97475 -1.16308 1.75568 6.69865 +5236 4 33.7915 11.6388 4.87314 3.4696 4.99202 0.68255 +5237 4 33.8545 12.8906 3.99294 -0.306808 -3.71184 -1.40707 +5238 6 21.4819 20.9256 37.2108 -8.76322 20.972 13.918 +5239 4 22.36 21.3309 37.2026 5.25525 -6.97128 0.105034 +5240 4 21.5739 19.9858 37.0637 7.9716 -15.2147 -3.23728 +5241 6 18.467 41.0278 0.654954 -19.554 -29.5721 -12.8619 +5242 4 17.5024 41.1258 0.530294 8.77033 6.01734 2.0842 +5243 4 18.8042 41.8885 0.845086 4.40915 26.8371 2.49279 +5244 6 41.3548 41.7118 25.1844 12.9409 14.5374 -0.392323 +5245 4 40.9222 40.8883 25.4041 -6.90081 -12.2223 3.22908 +5246 4 41.5202 41.6634 24.2378 -1.56977 -0.361026 -1.444 +5247 6 27.6369 28.1312 3.93858 39.9773 31.9241 -60.8173 +5248 4 27.7577 28.1455 2.91253 -1.05119 3.80663 52.0412 +5249 4 26.945 27.5412 4.09124 -36.8498 -31.9254 8.70709 +5250 6 18.2839 10.5111 31.4966 0.533258 -0.0130678 0.979798 +5251 4 17.4029 10.1636 31.5665 -10.6602 -13.9647 -0.00296819 +5252 4 18.1106 11.4466 31.5267 10.9856 11.4938 1.12981 +5253 6 11.3036 37.9694 14.764 4.77413 -10.0896 11.5971 +5254 4 10.7874 37.239 14.4221 -9.53089 5.23111 -9.63971 +5255 4 11.7579 37.5414 15.5118 -2.30342 16.6377 -5.07599 +5256 6 0.816524 18.1414 27.5647 20.1272 -0.3628 -0.469578 +5257 4 0.17179 17.4415 27.469 -11.396 -5.37013 -1.78049 +5258 4 1.63281 17.6507 27.785 -7.45447 11.2502 -1.88757 +5259 6 36.8008 10.7378 20.295 8.4208 9.86458 8.47872 +5260 4 36.1948 10.0642 20.0001 -9.44027 -8.16387 -5.04241 +5261 4 36.5983 10.8279 21.2363 1.65531 0.40354 2.85938 +5262 6 47.4201 25.5213 8.04394 8.74054 5.57223 -13.14 +5263 4 47.3566 25.6372 7.0634 -2.71671 -4.96685 23.4826 +5264 4 46.5708 25.2582 8.40304 -6.39129 0.734124 -5.55138 +5265 6 13.9238 35.1275 16.0037 32.5083 18.1998 3.59786 +5266 4 13.2022 34.5755 16.1957 -32.489 -30.3694 18.6715 +5267 4 13.7597 35.4303 15.121 4.25156 9.41728 -20.5426 +5268 6 29.562 35.3734 16.1776 -35.0835 -2.07929 -8.00281 +5269 4 30.2224 34.9599 16.7245 13.9673 -5.91711 9.2078 +5270 4 28.7051 34.8863 16.2926 25.5199 12.926 -4.35301 +5271 6 29.4722 25.8866 32.4187 14.354 2.72026 -23.1845 +5272 4 28.9025 25.7608 33.1796 -14.4011 -9.23541 2.43376 +5273 4 29.1922 25.3818 31.6086 -3.9853 6.0929 23.1903 +5274 6 24.1343 2.13601 25.4438 45.8363 12.8335 -27.0328 +5275 4 24.6226 2.81425 24.8647 -23.4035 -21.9591 22.2831 +5276 4 24.7019 1.32842 25.3981 -18.0817 13.4017 1.18969 +5277 6 4.54354 34.4275 19.14 11.1292 -12.0398 21.377 +5278 4 4.4735 34.5954 18.1883 -15.738 1.03246 1.7136 +5279 4 3.71635 34.4131 19.6775 9.89222 2.06937 -18.6971 +5280 6 10.1248 17.2257 14.3121 -1.66581 -5.60367 -9.60454 +5281 4 10.2583 17.5937 15.1679 8.8306 2.43924 21.0325 +5282 4 9.4989 17.8227 13.9164 -6.75609 1.38519 -13.487 +5283 6 21.4392 41.7587 34.6855 22.2624 7.769 -11.2018 +5284 4 21.5032 41.1211 35.405 -13.4071 -7.19641 7.36579 +5285 4 20.544 -0.0182627 34.3462 -4.72666 -12.2957 11.4101 +5286 6 36.1543 24.108 12.5954 -4.82194 -9.49577 -8.67068 +5287 4 35.691 23.694 13.3698 5.25066 1.62288 -23.6525 +5288 4 35.776 23.8018 11.7194 2.97337 4.42231 26.8685 +5289 6 49.5838 18.601 19.9434 7.37368 0.836531 -4.03301 +5290 4 50.0063 19.3607 19.4891 -2.40205 -12.3461 5.19746 +5291 4 50.2865 17.9356 20.0577 -3.44895 8.52353 -2.14521 +5292 6 1.26001 7.05318 14.4907 38.3056 -26.8237 -27.7837 +5293 4 1.8201 6.82299 13.6677 -23.9217 11.4061 34.9177 +5294 4 1.48256 6.35829 15.148 -4.21477 12.5307 -9.57675 +5295 6 12.7431 22.7759 31.2417 -21.5742 -17.6245 -17.2109 +5296 4 12.7068 22.0167 30.6251 -0.189583 12.5272 11.0438 +5297 4 13.6543 23.0267 31.2833 20.8009 4.17698 1.04357 +5298 6 8.18693 18.6259 27.8062 12.2535 -2.56913 -7.18349 +5299 4 8.40416 17.6764 27.919 2.05523 15.8207 -2.89848 +5300 4 8.90605 19.0032 27.258 -7.77238 -10.2714 7.52916 +5301 6 52.132 28.0244 15.3085 -5.0475 -8.46487 8.97907 +5302 4 52.2845 27.4141 14.5747 1.7297 4.34316 -0.517396 +5303 4 52.1194 28.9169 14.9336 2.1814 -6.82244 -4.33507 +5304 6 52.6909 21.916 10.0977 -8.33066 3.09691 2.06611 +5305 4 53.4463 22.3007 10.5387 10.5159 5.84972 4.87058 +5306 4 52.7807 22.2562 9.19728 -3.40401 -0.944397 -1.81328 +5307 6 22.3502 5.78024 2.67711 -1.19821 4.70475 8.9403 +5308 4 22.3462 5.61537 3.63751 1.98719 -8.03511 -7.01348 +5309 4 22.5962 4.95479 2.25163 2.53332 -12.0932 -0.158426 +5310 6 15.4205 16.2192 21.8867 5.02822 24.0999 -40.4778 +5311 4 14.4784 16.2102 22.0595 -10.022 -3.20892 10.2198 +5312 4 15.4767 16.6809 20.9929 2.09736 -16.6333 30.6862 +5313 6 28.7089 41.2927 33.91 5.52796 3.54283 5.25404 +5314 4 28.727 40.4953 34.4564 -2.79359 -2.24742 -0.170863 +5315 4 27.7951 41.4466 33.6263 4.57527 -2.88437 3.84631 +5316 6 9.01739 31.2727 18.2059 -18.1749 -3.84142 11.7815 +5317 4 8.98151 32.2312 18.3694 0.025829 -3.44513 1.18933 +5318 4 8.52849 30.7949 18.9304 13.8496 11.5721 -17.6376 +5319 6 20.5529 20.3981 18.1799 -10.2473 -3.12886 -8.71499 +5320 4 21.0329 20.6151 18.9854 0.125323 4.65459 7.73128 +5321 4 19.8496 21.0773 18.075 13.4895 -10.4913 3.92819 +5322 6 53.9703 14.7072 37.8312 5.01214 -4.5628 8.74013 +5323 4 53.4666 15.4974 37.9319 -5.56379 24.6001 14.4542 +5324 4 53.6093 14.375 37.0321 1.20033 -18.5897 -21.23 +5325 6 28.9035 15.3885 18.8586 45.4636 -15.1916 -0.680493 +5326 4 29.8469 15.0873 18.5932 -41.6456 12.1347 6.71251 +5327 4 28.9115 15.3505 19.8299 -3.5302 1.25595 -2.12016 +5328 6 2.00256 25.8212 18.9096 3.72723 11.471 14.7099 +5329 4 2.26458 26.6216 18.4327 2.14682 1.88771 -0.892997 +5330 4 1.76414 25.179 18.2501 -5.23937 -11.562 -15.1322 +5331 6 53.2507 40.704 24.2965 8.91441 12.4597 1.37217 +5332 4 53.4683 39.7911 24.0958 -2.511 -10.6834 -0.444896 +5333 4 54.079 41.1598 24.0633 -8.96863 1.63956 3.52407 +5334 6 47.5231 32.0042 22.8531 -14.3462 4.46803 -6.08063 +5335 4 47.3408 32.7709 23.4273 6.00779 -4.56073 2.25025 +5336 4 48.2766 31.5253 23.2067 4.67997 4.39959 7.43042 +5337 6 24.6197 26.1463 33.0089 -12.4366 -5.18424 3.68853 +5338 4 24.4183 25.6868 33.835 -4.3875 -0.159577 -1.83724 +5339 4 25.4547 26.5812 33.1385 10.0429 5.3772 -3.83199 +5340 6 21.3442 17.0884 39.4824 -9.75867 4.42788 -12.86 +5341 4 22.0786 16.6105 39.8509 9.0034 -0.419098 8.66004 +5342 4 20.9617 17.649 40.1682 3.71874 -0.284678 5.70811 +5343 6 11.0324 40.4486 17.0358 15.7971 -30.8577 -26.0801 +5344 4 11.6842 41.1185 17.2103 4.65986 12.9737 2.4903 +5345 4 11.491 39.8695 16.3608 -26.1319 15.9634 25.4848 +5346 6 20.3416 21.2702 39.8615 -24.9835 10.9638 22.3655 +5347 4 20.689 20.9793 39.0389 13.9219 -9.37305 -28.7546 +5348 4 21.0638 21.2843 40.4958 4.25493 1.29328 -0.298347 +5349 6 2.11091 29.6941 22.5934 -5.9509 -23.8702 -11.6938 +5350 4 1.45034 28.9715 22.5035 1.67869 13.3355 3.97539 +5351 4 2.94117 29.2559 22.3631 0.0654014 9.01208 -1.60678 +5352 6 36.7558 30.2897 35.4506 24.3729 -18.3256 16.5828 +5353 4 36.1768 30.1398 36.2224 6.47664 5.98183 -7.75951 +5354 4 37.6324 29.8684 35.7011 -26.9845 14.5763 -5.36474 +5355 6 12.9471 4.31284 37.9204 -6.90268 -11.166 6.10722 +5356 4 12.3078 3.59731 38.1765 12.7034 25.1114 3.17689 +5357 4 12.7446 5.19856 38.3152 -2.40344 -19.0082 -2.01981 +5358 6 38.3332 5.26794 18.4655 -19.3496 19.9027 -29.1997 +5359 4 37.4721 5.17942 18.8804 2.72791 -1.29988 8.64573 +5360 4 39.0241 5.01488 19.0552 15.587 -10.1496 24.0772 +5361 6 10.4858 9.23289 21.7404 -25.2332 -4.10139 2.16313 +5362 4 10.1465 9.25623 22.657 12.6022 -3.18555 -3.91704 +5363 4 11.447 9.27854 21.7188 5.40032 0.87934 7.2107 +5364 6 0.505771 41.0407 17.3245 -0.427706 37.3637 0.906459 +5365 4 1.03474 40.3115 17.5973 10.8601 -24.0642 8.3812 +5366 4 1.07952 41.8285 17.484 -10.202 -14.0113 -5.73388 +5367 6 4.10283 5.07754 6.43738 -38.2782 -14.6693 -26.7901 +5368 4 4.80956 4.44559 6.48511 17.8781 -6.62955 4.00539 +5369 4 4.33824 5.81877 6.9517 16.1672 26.1823 21.8329 +5370 6 11.4353 25.4218 0.164599 -6.84764 4.42394 -1.26617 +5371 4 11.3082 26.3017 0.56247 4.23965 -3.25035 1.30302 +5372 4 12.32 25.1006 0.40702 -4.64442 7.63092 -0.276853 +5373 6 7.41885 21.5502 8.10769 10.495 -13.722 -26.2993 +5374 4 7.61759 21.2522 7.17802 -11.0567 9.56016 28.8323 +5375 4 8.26229 21.8826 8.44859 -7.90548 -1.09713 -4.6635 +5376 6 47.5869 16.3678 25.2584 -15.0789 15.5873 -32.807 +5377 4 46.6352 16.1327 25.0388 32.9447 8.00435 6.4503 +5378 4 47.9767 16.8704 24.4584 -11.2605 -20.3751 33.7323 +5379 6 30.9209 19.4939 39.8451 -11.8548 28.7526 -24.1689 +5380 4 31.8555 19.5183 40.0202 17.1254 -10.6903 10.4692 +5381 4 30.8076 20.3562 39.3598 -8.87252 -26.4956 11.5622 +5382 6 20.3775 24.0331 39.393 16.2123 32.2964 -6.62361 +5383 4 19.46 24.2872 39.3788 -17.3162 -0.971439 2.40317 +5384 4 20.4139 23.0995 39.5119 -7.32592 -29.4126 2.4841 +5385 6 45.906 21.2665 41.1719 -24.2736 -11.4825 -0.885762 +5386 4 46.5804 21.1569 41.8486 15.7955 10.6383 -1.5802 +5387 4 46.0859 21.9477 40.5132 15.7742 6.36757 6.57249 +5388 6 32.5682 28.1996 30.46 3.6658 -10.99 6.0107 +5389 4 32.938 27.299 30.6104 -6.7941 21.8776 -2.09353 +5390 4 33.2105 28.8285 30.8344 -2.85996 -8.65293 -4.24176 +5391 6 18.0144 1.30598 27.0418 -16.6632 -1.71712 -0.445992 +5392 4 17.1007 1.69106 27.0468 26.0213 -5.17059 4.63351 +5393 4 18.4653 1.60291 27.8546 -9.34219 2.14994 -8.02835 +5394 6 39.3706 24.9704 21.8707 -3.8719 -7.6304 -3.05608 +5395 4 39.4638 25.9303 22.0078 -2.06007 -5.24545 2.56571 +5396 4 38.5004 24.7369 22.2528 8.08795 9.92494 -4.1564 +5397 6 33.5838 21.3134 22.0984 8.18441 -4.13225 6.82001 +5398 4 32.7138 21.3502 21.682 2.4933 6.37883 -5.99313 +5399 4 34.1113 22.092 21.8324 -12.1677 -4.37971 -1.53996 +5400 6 40.113 14.9986 15.7558 -14.3933 -54.3129 -47.4443 +5401 4 39.335 14.6192 15.2293 31.4969 18.6384 20.9479 +5402 4 39.7901 15.7154 16.2477 -17.7573 36.9578 24.811 +5403 6 32.6916 17.9228 6.36161 -9.89813 9.73379 -21.0853 +5404 4 32.6423 17.3002 7.0662 1.70901 -17.6566 26.5232 +5405 4 32.2464 17.4542 5.63975 -0.790726 3.03073 -5.51736 +5406 6 50.4678 15.9334 31.144 -39.7004 -26.5385 31.9374 +5407 4 51.253 16.1743 30.7093 39.9028 11.8107 -24.2063 +5408 4 50.5343 14.9829 31.3801 -1.18751 16.0768 -7.78774 +5409 6 23.825 29.3336 31.6412 17.8706 -6.79638 -8.14744 +5410 4 23.7507 29.695 30.7549 -4.03414 2.57591 0.878238 +5411 4 24.7016 28.8907 31.6365 -14.4802 6.46497 6.02506 +5412 6 25.0497 41.6479 38.28 3.49637 2.98657 -6.73496 +5413 4 25.6848 41.2957 37.6072 -14.3525 10.6226 12.6055 +5414 4 24.5759 0.544247 37.957 10.7828 -14.7666 -1.7986 +5415 6 14.3338 25.4719 8.00129 -34.0608 -17.9542 9.33499 +5416 4 15.0375 25.807 7.49197 32.7442 17.1809 -19.3974 +5417 4 13.7504 25.049 7.33286 9.67269 6.09785 11.4563 +5418 6 17.2157 20.7463 5.33337 -33.6161 12.1619 46.6806 +5419 4 17.4746 20.2104 4.61987 19.6997 -12.8632 -39.6831 +5420 4 17.6039 21.6267 5.33982 9.69266 2.06371 -12.0346 +5421 6 18.8632 10.9532 23.7128 -6.45661 -28.7698 -18.1749 +5422 4 18.5024 10.4645 22.9505 4.54871 -4.25462 9.96764 +5423 4 18.7195 11.8343 23.4273 2.43458 32.1183 3.28403 +5424 6 7.79185 41.3929 11.0465 3.42517 6.73563 9.75028 +5425 4 8.03468 40.5075 11.3396 -5.29569 0.405018 -3.04036 +5426 4 8.54504 0.0288503 11.3371 -5.83581 0.184768 -2.76634 +5427 6 48.7029 23.1861 34.0656 -21.7207 -4.36764 -18.9996 +5428 4 48.0685 22.9631 33.3267 17.6914 7.49561 22.5851 +5429 4 49.5647 23.2306 33.645 9.38657 -0.0360042 -3.96825 +5430 6 53.7171 23.5593 15.3279 7.98903 18.1369 9.52531 +5431 4 53.9889 24.0987 14.5512 -16.5338 -16.4319 -0.0123194 +5432 4 53.1679 22.8017 15.1046 0.0193492 2.24596 -12.2178 +5433 6 22.2331 5.62812 9.84443 -1.57081 2.06392 2.32933 +5434 4 21.8309 4.81719 9.48029 9.17546 11.008 0.0652314 +5435 4 22.6135 6.1669 9.11622 -10.9942 -17.7486 8.8339 +5436 6 33.6597 8.39756 9.07438 12.888 -3.30103 7.28088 +5437 4 32.9598 8.97334 9.38893 -12.3292 7.33717 0.65351 +5438 4 33.4682 8.16911 8.16186 -5.09418 6.09353 -6.44604 +5439 6 47.3119 37.7194 20.3363 21.5156 22.744 3.03657 +5440 4 47.6473 37.5407 19.4464 -9.46862 -8.33692 4.35957 +5441 4 46.6883 37.0359 20.5464 -12.6113 -19.4741 -3.99141 +5442 6 30.8566 16.7294 10.6197 -45.1927 -36.7422 15.3603 +5443 4 30.4293 17.2093 11.3782 10.0419 -7.15869 -15.9692 +5444 4 30.3248 15.8445 10.5087 28.8517 44.18 3.4025 +5445 6 48.1145 27.7388 10.1259 3.61398 12.7601 13.975 +5446 4 49.0121 27.5791 10.4269 8.16567 7.74751 7.8449 +5447 4 47.9875 27.049 9.49259 -14.0608 -13.1923 -17.2023 +5448 6 27.3333 38.6223 25.6028 2.23096 -19.4823 3.9502 +5449 4 28.2552 38.3493 25.5855 1.31221 -11.4567 4.08925 +5450 4 27.4115 39.4856 25.2253 -6.51803 21.9055 -3.11379 +5451 6 33.3641 5.73966 21.4502 -17.8674 16.1521 -18.7045 +5452 4 32.7333 6.1391 20.8022 11.3762 -13.0233 18.1576 +5453 4 34.2053 6.04196 21.1266 17.0109 2.35293 -3.511 +5454 6 25.3113 5.14231 4.52483 0.627568 -0.448638 -4.7772 +5455 4 25.9311 5.01166 5.26368 -5.83567 -1.85096 0.781095 +5456 4 24.4169 4.85751 4.79359 12.9854 0.158453 3.02285 +5457 6 40.4761 35.641 19.148 -1.79116 -1.08437 4.96155 +5458 4 40.617 35.2798 20.0294 1.97887 -12.6912 2.42284 +5459 4 40.4316 36.5735 19.3404 -1.08207 12.5153 -8.94186 +5460 6 49.6577 30.6259 19.0198 10.1565 -2.14928 -32.2041 +5461 4 49.9169 29.8714 18.4657 1.24638 0.0316256 -4.24874 +5462 4 49.4705 30.2089 19.8368 -7.31172 -12.6811 36.7039 +5463 6 42.1447 28.3235 17.0346 32.2065 -21.7575 -5.76428 +5464 4 41.8825 28.1658 16.1189 -9.06503 7.62036 -2.3435 +5465 4 42.9622 27.7534 17.0825 -24.1402 18.2728 2.552 +5466 6 47.7039 24.5139 36.3396 16.4403 6.39896 -6.79461 +5467 4 46.9537 23.9582 36.5487 -4.01092 -10.0931 -4.11437 +5468 4 48.0889 24.2445 35.4833 -10.0455 -7.86437 4.89019 +5469 6 19.3463 26.9837 19.8062 -14.9609 -0.640093 12.1457 +5470 4 19.5138 26.0435 19.7544 7.81166 -12.6546 -12.1749 +5471 4 18.7209 27.0489 20.5386 2.91516 7.38851 -4.99075 +5472 6 47.0534 26.8134 37.524 14.5946 -27.4581 20.3182 +5473 4 46.5999 27.4025 36.9765 -27.9132 42.868 -22.1392 +5474 4 47.3287 26.1433 36.896 5.92816 -9.16339 3.59921 +5475 6 9.30604 24.6864 40.2824 32.5721 -4.72803 4.84631 +5476 4 9.7425 23.8424 39.9878 -14.1318 19.2209 8.44319 +5477 4 10.0514 25.1942 40.7028 -19.8613 -12.5192 -10.8686 +5478 6 14.4861 17.9115 14.2864 12.9549 -2.10551 -8.28408 +5479 4 13.7677 18.2592 13.7435 1.92348 1.2648 2.86628 +5480 4 15.2633 17.8567 13.6783 -18.4643 2.67645 15.1406 +5481 6 37.1346 38.6824 18.7128 7.24689 -5.58535 -9.53541 +5482 4 36.7159 39.5508 18.578 6.84706 -0.690413 -9.37485 +5483 4 37.7177 38.457 17.9456 -10.6272 10.0511 7.65618 +5484 6 11.4119 5.91281 21.4549 8.51563 -6.63227 17.2429 +5485 4 12.0074 5.45436 22.0841 -12.0343 5.82261 -11.8758 +5486 4 10.9825 5.24051 20.9122 -1.087 -4.70833 -2.40093 +5487 6 4.25375 30.708 16.2346 29.3973 -34.9884 0.269827 +5488 4 4.09384 31.4404 15.6668 -11.3131 25.7038 -10.6546 +5489 4 3.7498 30.7826 17.0293 -13.4231 7.50595 13.7704 +5490 6 17.6719 16.0027 27.067 -23.8279 -26.0778 -36.6424 +5491 4 17.4271 15.046 26.968 10.0078 22.1048 9.82572 +5492 4 17.2008 16.3672 26.2667 15.5193 1.39518 21.9495 +5493 6 36.5109 8.65039 40.4308 12.8187 7.82554 4.51092 +5494 4 36.6212 9.57953 40.6523 1.70353 1.63484 0.0365135 +5495 4 35.6422 8.38915 40.7323 -7.59123 -4.26386 -1.28756 +5496 6 13.6114 12.9582 3.02589 -9.62347 -2.84414 10.0553 +5497 4 13.2363 12.4097 3.76862 19.3807 16.1747 -17.4749 +5498 4 14.4444 13.4268 3.2396 -7.87441 -9.64772 8.81761 +5499 6 38.5595 20.1494 21.6232 12.4359 -2.6335 16.4863 +5500 4 39.2259 20.3435 20.9591 -1.48691 0.443177 -6.45697 +5501 4 37.7118 20.0829 21.2013 -17.1516 -4.14152 -12.2545 +5502 6 50.9933 10.2578 30.842 -13.0607 -20.693 1.71035 +5503 4 51.4592 11.0512 30.6346 13.219 20.5706 -0.472754 +5504 4 50.4501 10.1493 30.0523 -4.00654 -4.85851 -2.78428 +5505 6 16.2749 2.41767 41.3132 30.43 46.2693 -10.4997 +5506 4 15.891 1.63581 41.6436 -18.412 -43.9133 0.0464609 +5507 4 16.2795 2.47169 40.3396 -9.09423 -14.5759 6.47164 +5508 6 16.5834 4.98938 41.8776 -7.21709 18.0228 -35.1788 +5509 4 16.7462 5.00964 0.881122 10.2158 10.5242 44.5139 +5510 4 16.3516 4.0781 41.7536 -3.71457 -12.9135 -9.58407 +5511 6 38.2173 37.6461 20.9885 34.7311 9.53448 3.02785 +5512 4 38.1039 38.1836 20.1861 -3.89758 -6.06348 6.62032 +5513 4 39.1638 37.7895 21.271 -30.6928 -4.57838 -6.40603 +5514 6 27.3006 1.89931 15.7822 -29.9599 0.296682 7.03709 +5515 4 27.5073 1.31215 15.0574 1.93116 -3.76907 -9.96281 +5516 4 26.3073 1.90747 15.8082 23.9237 -0.0762349 1.33551 +5517 6 29.0265 12.4386 37.8107 0.525722 -10.271 3.33822 +5518 4 29.5022 13.2884 37.7591 0.646351 -6.15481 8.15455 +5519 4 29.2991 11.9227 38.6151 -0.523918 21.8031 -11.8471 +5520 6 46.0742 20.1649 18.9021 10.3528 7.89056 -10.7305 +5521 4 45.1842 20.5502 18.8696 3.90233 0.901411 -3.14496 +5522 4 46.6469 20.7119 18.3183 -8.66547 -7.99067 8.59505 +5523 6 2.04022 38.6829 18.5084 -2.98341 9.82285 -40.3455 +5524 4 2.90324 38.7749 18.9245 -0.612017 -3.29975 20.9344 +5525 4 1.3228 38.3823 19.0758 6.43327 -3.78011 20.6074 +5526 6 44.0503 24.9822 25.9794 4.67294 -4.59524 3.88497 +5527 4 44.3373 24.0607 26.0767 4.76241 4.2408 6.41339 +5528 4 43.5759 24.9717 25.1449 -4.92835 3.44315 -2.97359 +5529 6 5.98031 26.6293 4.53551 9.30387 5.64625 14.1271 +5530 4 6.57491 27.1353 5.14729 -11.3776 -17.0368 -12.135 +5531 4 6.21313 25.677 4.5841 -4.82905 19.4284 -2.02229 +5532 6 0.0924267 23.2133 10.9333 1.42961 0.53672 3.80218 +5533 4 0.717354 23.7388 10.4004 2.9288 -9.65077 10.1872 +5534 4 0.580921 22.6863 11.5989 -3.01683 9.30052 -9.37626 +5535 6 39.1222 20.6154 12.8741 28.3348 2.95161 0.461931 +5536 4 40.0468 20.8249 13.1753 -23.4009 -9.33487 -2.82098 +5537 4 38.9932 21.1408 12.0685 -0.0080483 -0.226832 2.68059 +5538 6 39.959 39.9495 18.871 8.01281 1.93571 -21.8826 +5539 4 39.6441 40.4313 18.0693 6.09748 -11.7745 18.4856 +5540 4 39.3412 40.1359 19.5607 -16.2687 5.42221 11.8382 +5541 6 49.288 23.0046 30.5128 21.2206 -9.75551 18.5897 +5542 4 49.5389 23.7528 30.0013 -1.98497 24.1116 -29.9204 +5543 4 49.9896 23.0569 31.1809 -5.40626 -11.587 6.30696 +5544 6 10.3545 2.34292 9.14765 -20.562 40.259 12.8074 +5545 4 10.1012 1.5797 8.68555 -3.02669 -36.876 -18.9145 +5546 4 9.58966 2.94108 8.9894 20.4134 -0.423974 9.05106 +5547 6 9.6115 40.9317 19.7379 12.0905 -27.6191 -4.08509 +5548 4 9.69139 40.7751 18.7589 3.32448 -0.840478 24.839 +5549 4 9.96472 40.0953 20.2033 -15.7711 32.9781 -27.126 +5550 6 29.2535 5.10379 17.4957 6.62295 15.7752 6.05206 +5551 4 28.9547 4.7998 16.6324 -1.76299 0.290572 -5.22762 +5552 4 29.5626 6.02275 17.3534 -3.29284 -14.1281 1.20249 +5553 6 27.0956 15.411 3.22262 8.43004 -47.4217 3.28637 +5554 4 27.2677 16.3043 3.38591 1.16524 52.1129 6.18754 +5555 4 27.741 14.9724 3.82188 -13.792 3.46242 -10.72 +5556 6 32.8341 39.3821 25.1177 -1.66938 -44.1854 21.376 +5557 4 32.6253 40.2767 24.9331 -7.27917 31.8978 1.68524 +5558 4 32.4689 39.1753 26.0219 6.68592 11.3878 -26.9617 +5559 6 34.9613 7.8883 31.2358 4.6626 36.0744 6.61898 +5560 4 34.1778 8.39814 31.5057 7.62156 3.23778 -2.6687 +5561 4 34.6431 7.01199 31.2355 -6.57887 -35.8668 -2.78431 +5562 6 6.13276 36.7597 26.1434 10.8988 16.6869 20.3463 +5563 4 6.63888 37.4372 26.6797 -12.2659 -21.448 -21.9021 +5564 4 6.61066 36.5785 25.3331 5.0666 0.722926 -2.43587 +5565 6 6.00975 25.8323 24.1014 -4.47961 0.932019 -2.36624 +5566 4 6.35352 25.3647 24.9068 -18.3984 14.8695 -13.0656 +5567 4 5.16189 26.3111 24.2876 18.65 -15.8322 7.58859 +5568 6 45.6302 24.3945 2.56021 19.8484 -5.54431 -0.0961329 +5569 4 46.4674 24.0527 2.19931 -2.34639 0.0383291 -2.49188 +5570 4 45.6784 24.1611 3.48508 -4.52597 -1.56916 11.2469 +5571 6 15.5147 11.7041 32.683 14.9804 20.126 19.7749 +5572 4 15.7333 12.537 33.1619 -4.31998 -20.325 -9.45866 +5573 4 14.9494 12.0119 31.9786 -9.0483 1.88099 -11.1618 +5574 6 46.4109 17.7015 37.4781 -27.0258 -32.7931 -28.9932 +5575 4 46.5427 17.8951 38.3867 3.19976 6.65122 29.0636 +5576 4 45.8763 16.8534 37.4192 15.4316 28.8096 -0.764517 +5577 6 39.7197 20.9143 18.534 -24.0731 20.2285 32.8184 +5578 4 40.3775 20.5463 17.9571 20.7324 -0.0260386 -6.5243 +5579 4 40.0771 21.5962 19.1648 -0.0511872 -19.8333 -22.8182 +5580 6 23.8035 28.041 36.6748 9.0016 14.1447 -6.24075 +5581 4 23.3139 27.2938 37.064 2.44252 16.2828 7.25552 +5582 4 23.789 28.845 37.2599 -7.88527 -27.7019 -2.97202 +5583 6 23.2344 0.634844 30.8976 -0.384503 -14.0448 -5.97485 +5584 4 23.3889 41.8653 31.5825 6.30765 2.44689 -9.38002 +5585 4 23.8441 0.49945 30.133 -8.72578 -2.57312 14.648 +5586 6 37.1436 6.89172 28.2858 -3.37167 6.44507 30.6351 +5587 4 36.8056 6.23733 28.9583 11.2574 17.9183 -21.3683 +5588 4 37.4325 7.68669 28.8192 -8.94015 -21.4647 -17.7418 +5589 6 3.23535 6.60909 12.3935 -1.87368 1.73448 8.36027 +5590 4 3.03832 6.9284 11.4867 8.20532 -9.84476 7.71099 +5591 4 3.52123 5.67427 12.3822 -6.77188 11.8795 -6.70084 +5592 6 12.6173 19.1518 31.1213 -5.69854 -18.2223 8.29425 +5593 4 12.5903 18.2248 31.5183 -0.203161 27.8336 -18.7857 +5594 4 12.2771 19.1425 30.2049 2.23067 -5.60852 14.6148 +5595 6 15.1884 38.3149 41.5578 -3.57026 -0.303434 0.776802 +5596 4 15.4085 38.7623 40.7331 -1.55695 3.41656 0.7558 +5597 4 16.0064 37.8692 41.7958 4.70682 -3.66196 2.37744 +5598 6 49.6308 33.3399 19.6427 -23.754 -26.2674 -4.71234 +5599 4 48.6425 33.4171 19.8493 35.7001 -9.4047 -10.4581 +5600 4 49.8006 32.395 19.3286 -9.63678 35.3831 11.1391 +5601 6 6.36026 2.78098 29.8944 3.74937 13.951 -9.77631 +5602 4 6.39713 3.75696 29.8119 -0.635871 -14.0149 2.80012 +5603 4 6.09114 2.63212 30.8044 -1.55083 -4.44243 9.60337 +5604 6 13.1715 31.7798 30.2783 -11.6407 3.9064 -21.9894 +5605 4 12.793 31.9725 29.3819 8.72012 -0.590438 18.6573 +5606 4 12.9685 30.8401 30.4245 2.82441 5.28785 4.26217 +5607 6 32.3245 32.246 24.8932 -0.334642 -17.4514 3.51608 +5608 4 32.5833 31.3985 24.4266 1.55373 29.7789 3.70352 +5609 4 32.7413 33.0821 24.5914 4.2936 -14.9539 -9.40787 +5610 6 41.9919 14.5701 37.4124 -31.8928 -38.2057 -11.1184 +5611 4 41.1925 13.9916 37.278 11.7187 28.3557 2.93562 +5612 4 42.6351 13.8531 37.4242 20.2579 6.94588 1.70752 +5613 6 11.8923 7.24234 27.6655 -13.1666 -25.4093 6.94854 +5614 4 11.7936 6.42612 28.2118 8.91213 18.8361 -2.40188 +5615 4 11.255 7.06027 26.9538 4.64331 9.73453 -0.841263 +5616 6 14.1973 37.538 6.88791 4.07782 -38.2298 -28.3639 +5617 4 14.4575 38.4426 6.80778 6.05638 30.4198 1.96843 +5618 4 14.5936 37.1092 6.07523 -12.6749 10.0326 27.426 +5619 6 14.2479 30.6948 36.0545 7.37408 36.4971 9.0133 +5620 4 14.3981 30.7629 35.1101 2.39159 -10.6067 -11.9788 +5621 4 14.1779 29.7876 36.2972 -1.09854 -35.7585 -0.14866 +5622 6 16.4334 33.6494 5.49228 -9.96541 -28.1856 -5.39099 +5623 4 16.7983 34.5397 5.45321 9.37649 -3.55324 -12.1003 +5624 4 16.7788 32.9912 4.81355 -0.655183 31.9156 12.6517 +5625 6 23.0317 17.1547 7.8473 13.6053 -0.132883 9.10362 +5626 4 22.1841 17.362 7.40272 9.91908 10.567 10.3381 +5627 4 23.4804 17.9296 8.30446 -24.7767 -19.3244 -18.4116 +5628 6 51.7425 20.8913 27.7088 32.6403 -5.30395 6.54704 +5629 4 51.4526 20.615 28.6066 9.31531 5.01366 -13.1678 +5630 4 52.7523 20.9899 27.7096 -40.0215 -4.95426 2.55021 +5631 6 2.19474 27.6072 28.8013 -23.9703 3.8216 12.4498 +5632 4 2.89306 28.2617 29.0045 8.22653 -14.998 -10.5048 +5633 4 2.42593 26.8662 28.2089 10.4722 10.3682 5.46115 +5634 6 17.2069 14.3387 7.70681 0.210359 -30.5014 22.2216 +5635 4 16.8342 14.1932 8.62484 13.2745 1.87397 -27.442 +5636 4 17.791 13.5503 7.49447 -17.8498 26.4292 5.4189 +5637 6 12.462 8.93964 14.7065 0.798528 8.71873 -6.67623 +5638 4 12.2438 7.98523 14.5568 11.6803 11.8078 17.0064 +5639 4 13.0577 9.12873 15.4809 -12.5262 -17.6243 -12.8578 +5640 6 42.4139 38.0579 9.76413 -20.5008 17.2265 16.0611 +5641 4 43.2035 37.8944 10.2554 20.3834 -6.45835 6.72371 +5642 4 41.8905 38.6035 10.3913 3.31942 -7.4886 -15.3201 +5643 6 51.8227 30.3513 28.272 -27.6927 -20.9124 31.2363 +5644 4 51.4089 31.1514 27.9711 0.163888 16.7369 -10.597 +5645 4 52.6546 30.2313 27.8441 24.1641 3.9866 -16.3823 +5646 6 0.181148 18.531 4.58976 -5.95747 22.8787 14.3331 +5647 4 0.30783 18.164 3.72574 1.94264 -10.8238 -19.8991 +5648 4 0.385506 17.861 5.23812 2.38695 -15.8688 4.81738 +5649 6 34.1492 0.61754 2.99129 -49.6439 4.42439 -16.0687 +5650 4 33.2398 0.938351 2.63038 43.5613 -10.8791 15.5023 +5651 4 34.8325 1.13587 2.566 3.67212 10.3309 -6.27046 +5652 6 49.171 17.2374 23.1529 12.6877 -22.0026 -17.2704 +5653 4 50.1002 17.5391 23.0823 -12.4494 -3.65532 2.68691 +5654 4 49.1558 16.3609 22.6932 2.16788 22.8154 9.36775 +5655 6 23.1488 6.5083 23.6124 -20.5997 37.6057 -45.0229 +5656 4 23.0491 7.12001 22.8007 18.1878 -21.95 27.0503 +5657 4 22.2316 6.45775 23.8939 -1.28085 -6.53623 13.7239 +5658 6 11.0806 24.0842 29.2705 -8.73998 -10.3514 -18.9502 +5659 4 11.2441 23.4599 28.5168 0.0150655 10.4905 16.9308 +5660 4 11.7296 23.9083 29.9561 7.87164 -2.5542 2.12029 +5661 6 36.5429 4.08242 21.672 0.786556 -8.94696 -15.3954 +5662 4 36.4501 4.49554 22.5359 -3.35109 8.47972 1.84417 +5663 4 36.356 4.76727 20.9996 1.47044 -5.20042 11.1851 +5664 6 31.3053 25.6355 24.591 -3.66138 3.71718 3.54675 +5665 4 31.1335 26.2845 25.3159 5.93159 -20.4343 -13.8963 +5666 4 32.0778 25.0682 24.8002 -7.66178 11.3294 7.22687 +5667 6 42.6065 23.0403 14.7613 -16.8309 4.03618 -45.3098 +5668 4 42.9655 23.4598 13.9577 -8.276 -4.36486 -1.00498 +5669 4 43.204 23.3098 15.4118 29.6291 10.3091 46.448 +5670 6 14.3159 11.6727 8.8813 -14.5655 -17.9373 -12.2817 +5671 4 13.3434 11.4421 8.85146 29.9821 6.96631 -2.22077 +5672 4 14.7728 10.9717 8.34565 -11.3371 15.3318 14.175 +5673 6 21.498 2.14139 3.39648 14.7702 -17.8734 -6.06988 +5674 4 22.405 2.21099 3.73647 -11.0312 3.8274 -0.37696 +5675 4 21.4855 1.24815 2.9799 -4.51333 14.3419 9.54204 +5676 6 22.4606 27.6741 39.0725 -9.38699 -8.57051 -12.0691 +5677 4 22.9487 28.2157 39.6788 9.87489 12.9386 7.45564 +5678 4 22.251 26.9021 39.5804 -3.7481 -10.0177 3.53978 +5679 6 37.2705 33.4961 30.0614 -4.9469 -17.1986 11.1636 +5680 4 36.5019 32.9393 30.3108 14.0133 8.69925 -1.52787 +5681 4 38.0636 33.0902 30.4641 -13.5236 2.40347 -6.71067 +5682 6 41.8394 20.8621 40.0097 -20.8091 -17.9415 -11.9484 +5683 4 40.8821 20.7467 40.2088 17.4772 5.45688 -4.89215 +5684 4 42.2425 21.2111 40.795 8.11745 4.61319 15.3924 +5685 6 10.0509 31.1054 22.2556 20.3961 -18.8014 17.2446 +5686 4 9.98499 30.8639 23.2007 -4.95143 3.66172 -13.3958 +5687 4 9.23459 31.4918 21.9926 -24.2979 8.76968 -3.95477 +5688 6 24.2243 35.3747 6.62617 -9.42531 -3.96828 -6.7527 +5689 4 23.2865 35.2144 6.56466 -9.91939 -6.68958 -24.4488 +5690 4 24.2401 35.6133 7.54088 22.4532 10.3619 17.5563 +5691 6 54.2249 13.3694 18.759 -24.737 -0.349871 -1.41807 +5692 4 53.5933 13.3703 18.006 15.3609 1.78219 9.05355 +5693 4 53.6566 13.499 19.5435 10.7967 -0.400371 -8.89572 +5694 6 12.4855 25.1013 17.4456 -6.57337 13.5018 5.68311 +5695 4 11.9686 25.7405 17.9864 9.67417 -13.0798 -6.23069 +5696 4 12.9177 24.4729 18.0482 -8.67745 6.31928 -4.55572 +5697 6 22.3956 33.969 18.8874 -5.8063 -1.6479 -7.81353 +5698 4 22.8035 34.4497 18.1359 -8.0332 -6.19684 5.18696 +5699 4 21.6693 33.408 18.5182 22.6878 13.045 2.20471 +5700 6 24.4435 12.9292 5.84415 8.74588 -19.8564 16.0901 +5701 4 24.6262 13.8512 5.99703 -0.326218 20.1414 -4.57271 +5702 4 23.8078 12.8376 5.13214 -2.90401 5.95194 -4.82348 +5703 6 13.3959 11.2335 28.6038 -6.74888 -5.61354 -5.54718 +5704 4 13.7674 10.4842 28.0847 -9.93712 8.82772 12.9583 +5705 4 12.6218 10.8864 29.0903 8.08376 -4.51111 -11.0518 +5706 6 20.9645 34.7015 21.139 -6.51648 1.45471 -0.425004 +5707 4 21.4543 35.0255 21.9119 2.52902 -3.67403 -7.94594 +5708 4 21.5071 34.7067 20.3201 -1.1119 -0.149268 16.7291 +5709 6 37.136 34.5081 26.161 6.62209 -8.97684 -22.2932 +5710 4 37.2438 34.333 25.2112 -5.73965 -6.14541 10.65 +5711 4 37.5173 35.375 26.2088 1.33918 12.2816 12.8311 +5712 6 49.3593 27.1123 23.4681 27.9614 -13.0657 2.71617 +5713 4 48.46 27.3383 23.3348 -38.0547 10.3981 -3.53627 +5714 4 49.5827 26.632 22.6632 1.14175 -6.15755 -6.01297 +5715 6 2.6463 41.7198 27.6524 7.3894 17.9878 -25.5957 +5716 4 2.49639 41.7504 26.6775 -8.79282 -10.4379 14.5056 +5717 4 3.38399 0.440368 27.7439 -10.0848 -7.80081 10.7778 +5718 6 28.2486 5.66281 0.851705 -28.2484 -11.3463 5.20358 +5719 4 29.1342 5.88017 0.643235 30.8656 11.4658 -5.99415 +5720 4 28.269 4.69693 0.891643 -4.88577 1.64465 1.4719 +5721 6 46.3319 19.9354 30.6504 10.2867 19.401 8.99033 +5722 4 46.9123 19.9353 29.8821 -3.84989 -4.07474 -6.11394 +5723 4 46.5975 20.7732 31.0971 -12.3274 -18.5124 -2.17733 +5724 6 3.63748 25.7835 21.5531 -13.3498 -8.40935 -29.3244 +5725 4 3.82697 24.8656 21.7578 10.5845 0.467441 11.0774 +5726 4 3.24958 25.6945 20.6565 5.98204 10.7305 11.6574 +5727 6 2.75525 19.0991 29.6309 -15.3907 3.66354 13.2976 +5728 4 3.52302 18.6052 29.9384 7.69741 -2.11378 -3.28897 +5729 4 2.98375 19.5594 28.8227 11.6258 3.58084 -5.99316 +5730 6 11.8998 35.7779 24.2574 -1.81403 7.91701 -5.71356 +5731 4 12.4147 34.9912 24.3376 10.7342 -20.9531 7.85436 +5732 4 12.5443 36.3811 23.8879 2.19538 16 -3.69366 +5733 6 52.3427 30.4062 14.294 22.5839 4.39347 1.37497 +5734 4 52.8745 31.0934 14.7488 -8.66891 -1.23278 -4.46489 +5735 4 51.4935 30.7804 14.0876 -13.5204 11.8147 1.32314 +5736 6 0.0822874 24.3672 32.1291 -8.34182 -9.5272 -6.40877 +5737 4 0.828194 24.8082 31.7001 -5.59692 5.0286 6.41936 +5738 4 -0.0482457 24.7479 33.0025 4.35174 8.79498 5.58774 +5739 6 31.4966 23.7292 38.8152 19.1094 38.0757 -4.99319 +5740 4 31.5999 23.5133 39.7508 -8.21927 -12.2318 -1.63758 +5741 4 30.9751 23.0699 38.3783 -13.0662 -23.7861 4.62116 +5742 6 52.1169 21.6052 3.50792 14.3711 -14.904 -13.5765 +5743 4 52.8807 21.6364 2.89306 -16.3122 -4.91238 6.22228 +5744 4 52.1257 22.4771 3.8768 -2.65107 18.1744 9.91254 +5745 6 31.7478 33.9414 11.5999 6.40399 -14.705 -7.35618 +5746 4 31.326 34.316 12.3745 -3.98661 3.76902 9.36008 +5747 4 32.1024 33.0666 11.8569 -5.74966 15.1553 -0.43871 +5748 6 7.04869 17.6722 16.6738 15.5169 9.78585 -46.6303 +5749 4 6.86408 17.1452 17.4554 -1.12856 -17.4359 1.80272 +5750 4 7.18951 17.0724 15.8577 -9.09698 16.5018 49.1326 +5751 6 51.856 41.8666 22.1892 3.84753 25.5265 -21.3427 +5752 4 52.3772 41.4924 22.8897 9.65371 -13.9556 16.5062 +5753 4 51.0512 41.3628 22.1522 -12.8828 -14.9996 6.2925 +5754 6 50.8708 9.92691 25.9357 -19.3562 -16.2947 3.52683 +5755 4 50.5833 10.1225 25.0455 -2.85771 2.39787 -5.58996 +5756 4 51.6551 10.4289 26.0882 17.2727 16.0662 4.10656 +5757 6 8.99927 39.8664 13.8488 -8.14038 -13.6283 -23.156 +5758 4 9.59929 39.3497 14.3885 6.06913 -3.61279 3.55219 +5759 4 8.79522 39.3067 13.0547 7.60199 16.2117 22.1745 +5760 6 40.7023 25.5302 0.148896 6.79038 -13.4508 8.01702 +5761 4 40.3789 25.4701 1.07476 14.4856 1.96217 -11.1718 +5762 4 41.6802 25.6099 0.149801 -17.1473 -2.90233 2.89792 +5763 6 46.6909 7.84537 22.8702 9.17253 9.27189 2.7581 +5764 4 46.223 7.4121 23.6122 6.69651 11.5962 -1.82232 +5765 4 47.0858 8.70418 23.1544 -10.5797 -14.2101 5.83025 +5766 6 21.013 12.9106 9.96683 -11.4772 33.9385 12.3935 +5767 4 21.4714 12.292 10.5062 17.1864 -22.5118 18.142 +5768 4 21.2487 12.7153 9.07972 8.38308 -10.8862 -30.7653 +5769 6 24.8549 0.515446 28.6008 5.68052 19.4063 -7.13145 +5770 4 24.6132 0.0822417 27.7678 -2.25298 -0.561161 -0.933523 +5771 4 24.9931 1.46483 28.3802 -3.69568 -16.6941 4.65055 +5772 6 9.93738 22.6806 8.27387 -17.0851 30.8612 6.83622 +5773 4 10.4469 21.9921 7.84938 5.97494 0.327216 -18.4105 +5774 4 9.65147 23.3826 7.61609 12.4321 -25.0338 8.46255 +5775 6 33.2759 9.25001 23.8237 4.47891 -44.2955 15.8461 +5776 4 33.2652 10.105 23.448 0.909732 36.8069 -18.0196 +5777 4 34.1325 8.84557 23.5962 -5.93924 6.51534 1.57833 +5778 6 47.795 20.3665 34.2866 5.36639 25.6433 -13.2606 +5779 4 47.2589 21.0165 33.753 7.81309 -27.8153 16.882 +5780 4 47.2984 19.5618 34.502 -10.2742 8.68957 -7.27829 +5781 6 7.49437 13.498 41.0843 -1.51987 -1.91843 -16.5508 +5782 4 7.4491 13.1887 40.147 4.71488 4.53153 18.247 +5783 4 8.31974 13.1617 41.4819 -4.68073 -1.19795 -7.02436 +5784 6 9.95832 23.5973 1.60681 5.21402 2.49741 5.68021 +5785 4 10.4402 24.1882 0.998507 -5.12041 -6.82862 1.89989 +5786 4 9.65493 22.8254 1.1174 1.14228 -2.219 -8.51506 +5787 6 27.3184 14.1623 11.3341 -13.0256 18.3326 19.191 +5788 4 27.0532 14.8043 10.6617 -0.288735 -3.87647 -1.15481 +5789 4 27.1082 14.6278 12.1878 10.7132 -11.7932 -20.1286 +5790 6 25.8363 31.783 17.8928 12.257 -31.4953 -8.75538 +5791 4 26.5912 31.2312 17.6268 -16.3657 -3.28218 2.7807 +5792 4 26.257 32.5845 18.0942 8.13437 40.9862 10.9181 +5793 6 28.5106 34.3419 0.227626 33.3873 17.7784 12.057 +5794 4 28.9852 33.8482 0.904042 3.3493 0.859906 2.37016 +5795 4 27.7339 33.8559 0.0766936 -35.6263 -19.3635 -8.63216 +5796 6 39.4752 27.6784 22.7097 42.3367 15.2059 -23.9811 +5797 4 38.5679 27.9307 22.8105 -22.3645 11.7157 0.32019 +5798 4 39.9498 28.4084 22.1978 -16.9125 -22.6846 16.1018 +5799 6 19.4034 35.5119 37.6428 33.5095 -11.1022 16.798 +5800 4 18.7953 34.9333 37.2031 -16.031 -7.23993 -11.3762 +5801 4 20.0399 34.8524 38.0282 -15.2165 20.9239 -9.15559 +5802 6 40.2577 30.223 10.7322 40.2352 -13.6393 -47.8395 +5803 4 40.0003 30.153 11.624 -20.3139 3.96126 40.955 +5804 4 39.7054 30.7997 10.2038 -14.6911 14.5022 3.62333 +5805 6 44.8252 28.467 36.0943 -27.9317 -39.6182 20.2271 +5806 4 44.1 27.9067 36.617 42.0807 42.9759 -26.5645 +5807 4 44.8315 29.4044 36.3472 -5.71594 -8.07431 0.279077 +5808 6 17.9328 13.9421 34.2756 -23.0398 37.6904 -16.8553 +5809 4 17.2847 14.658 34.0723 21.6532 -14.16 -3.36915 +5810 4 17.4769 13.4978 34.9742 -2.33669 -21.4636 20.9706 +5811 6 22.7722 11.8049 25.9053 18.1639 13.4769 -8.32772 +5812 4 22.5143 10.954 26.1764 -32.0329 -27.8082 11.3637 +5813 4 23.7113 11.6387 25.939 19.9678 17.8754 -6.33473 +5814 6 27.9844 31.9785 40.3628 4.4159 -7.73511 16.6787 +5815 4 28.3104 32.752 39.9101 2.36742 5.81951 -9.83175 +5816 4 27.6866 31.3262 39.7216 -3.89657 2.92736 -3.90823 +5817 6 29.7056 5.13899 29.6966 36.1554 -28.1732 -9.81385 +5818 4 29.3242 5.52633 30.4675 -11.5775 13.5815 21.5043 +5819 4 30.5867 4.74321 29.9895 -34.1051 15.4003 -14.984 +5820 6 3.10893 21.4798 2.76501 -7.99866 -19.5262 -7.43282 +5821 4 2.82658 22.3873 2.73831 -4.86294 14.1814 1.21532 +5822 4 2.47005 21.0041 2.20282 6.80672 4.92349 5.4824 +5823 6 13.6497 30.6638 39.7451 -45.1888 -1.5 -27.4221 +5824 4 14.5316 30.8766 39.996 26.4643 7.88404 -4.33129 +5825 4 13.4124 30.9677 38.8135 13.6057 -6.06521 34.9266 +5826 6 39.188 23.0895 28.2562 15.2318 22.185 -40.3341 +5827 4 39.2961 23.1894 27.2636 -4.5014 -1.37473 28.8386 +5828 4 38.6302 22.3345 28.3879 -14.2617 -17.3372 5.24228 +5829 6 16.9988 23.7489 0.769214 20.7079 -15.4466 5.05665 +5830 4 16.2107 23.4786 1.24898 -3.68938 2.33828 -2.20359 +5831 4 17.6949 23.1909 1.19915 -10.9726 17.7258 -9.6056 +5832 6 0.328251 33.6592 13.0294 5.05621 13.0457 -18.8804 +5833 4 55.0348 32.9975 13.677 0.78154 12.2617 9.8199 +5834 4 0.388277 34.5816 13.3997 -6.36603 -34.6234 2.68168 +5835 6 49.1005 40.6595 16.9496 -9.76098 4.73909 -13.8177 +5836 4 49.2151 40.9775 16.0207 -4.23419 -6.48803 14.4163 +5837 4 48.1506 40.7848 17.1408 8.79948 2.71791 -6.65809 +5838 6 52.1337 39.9918 15.1756 26.7545 10.0433 -2.50902 +5839 4 51.9708 40.0067 16.1202 -6.38877 -4.81519 5.40892 +5840 4 51.3465 39.7494 14.7166 -22.4824 -4.17003 -7.64187 +5841 6 29.052 37.1033 37.836 19.097 -0.968932 -4.5801 +5842 4 29.682 36.5364 38.3049 -8.87198 1.40853 -5.4338 +5843 4 28.3717 37.2982 38.474 -12.8547 4.6316 9.68073 +5844 6 4.87585 1.47991 27.5772 1.0193 4.57332 -1.4391 +5845 4 5.21258 1.06654 26.7686 1.92757 2.57678 7.5628 +5846 4 5.62617 1.67061 28.1638 -3.61661 -2.55781 -2.1886 +5847 6 43.5959 24.3463 30.211 -19.7182 -5.92862 14.3815 +5848 4 44.3514 23.9347 29.8066 13.2495 -10.0411 -7.84874 +5849 4 42.954 23.6392 30.3929 6.93549 5.0637 -4.64144 +5850 6 33.7524 3.52358 22.9355 4.65558 -3.45748 -24.1115 +5851 4 34.2253 2.7722 22.5212 -9.10678 14.6802 11.3369 +5852 4 33.6063 4.18077 22.2154 2.29559 -11.8514 17.7295 +5853 6 19.8909 13.4517 25.3922 5.25873 -5.74859 -7.9771 +5854 4 20.5096 14.0736 25.7535 5.66529 16.002 2.33546 +5855 4 19.9521 12.7313 26.0185 -3.34295 -15.2779 0.0169051 +5856 6 47.3737 23.1767 39.6212 -5.95621 11.0118 4.46955 +5857 4 47.7191 22.5265 39.0041 4.75348 -8.18234 -7.77672 +5858 4 47.7813 24.0201 39.3891 1.84918 -0.94156 0.213564 +5859 6 20.1771 18.6734 32.3906 -2.68035 -24.6067 18.319 +5860 4 19.7167 19.3347 31.8914 0.274713 15.8779 -14.5216 +5861 4 21.1289 18.7867 32.3383 1.39014 4.37005 -4.23212 +5862 6 0.462706 5.80795 25.6713 -7.84599 -7.21428 -45.242 +5863 4 0.323825 6.56383 25.0471 7.25451 -11.4554 20.6165 +5864 4 0.632949 6.14438 26.5418 1.37183 20.4375 17.7538 +5865 6 6.87393 19.55 31.9207 -32.7339 30.668 -22.5905 +5866 4 6.24577 19.9891 32.5577 15.6688 -11.8235 -17.9631 +5867 4 6.64633 19.9665 31.0139 13.7505 -20.7976 33.8805 +5868 6 6.72837 20.2799 38.5105 -3.64262 3.78431 -13.5507 +5869 4 5.92588 20.8248 38.5086 9.85336 -2.70512 -1.72466 +5870 4 6.83039 19.9897 39.4188 -3.49896 1.12624 1.5432 +5871 6 22.0356 25.927 12.2605 -11.8373 -4.76705 -8.63625 +5872 4 21.2326 25.5939 11.7351 40.6868 7.42656 16.975 +5873 4 22.8707 25.497 11.9923 -13.8486 -7.11072 -10.1952 +5874 6 39.3057 7.93299 2.64755 -0.118713 9.42534 0.0803503 +5875 4 39.6638 8.10481 3.53463 2.86319 -1.68774 -0.268253 +5876 4 39.5974 7.06378 2.35963 5.09861 -8.7519 2.38745 +5877 6 29.9647 22.0457 34.4057 2.14844 7.25734 -28.1517 +5878 4 30.9338 21.915 34.3365 -18.2911 3.03872 -0.832433 +5879 4 29.6238 22.2503 33.4865 4.56359 -4.84177 28.516 +5880 6 37.5951 16.2788 0.369586 8.64826 -19.3515 -0.400608 +5881 4 37.1939 15.3927 0.526929 9.97291 14.3398 -5.3998 +5882 4 38.4404 16.082 41.8172 -10.5319 -0.823814 4.55326 +5883 6 11.7218 13.8845 21.8896 14.7882 -39.2126 -46.5495 +5884 4 11.9305 13.3995 21.0267 -7.58848 27.5443 23.8472 +5885 4 11.7147 13.1405 22.4934 -2.11531 -1.20748 18.2217 +5886 6 33.352 10.9238 27.6262 4.19409 14.5082 -21.7958 +5887 4 32.741 11.5866 27.2704 3.79692 -6.80494 8.02232 +5888 4 34.0591 10.8732 26.9373 -11.2958 -2.76298 18.1193 +5889 6 30.9422 36.5217 10.1011 0.546516 -38.0529 -7.53065 +5890 4 31.037 36.4313 9.10316 -3.7795 -1.86296 33.6151 +5891 4 30.9555 35.5897 10.5034 1.2522 32.9448 -19.5962 +5892 6 45.5828 6.56917 25.2425 13.4794 -38.3135 -0.0969536 +5893 4 44.6735 6.51564 25.4913 -20.1668 12.9455 3.79285 +5894 4 45.8221 5.605 25.2656 2.31227 28.4662 -4.04899 +5895 6 9.53612 30.0233 12.041 13.8898 -20.9008 -19.4413 +5896 4 9.92894 30.5763 11.3437 -1.97905 0.820167 2.98642 +5897 4 9.13364 30.6129 12.6538 -15.721 17.9312 16.9413 +5898 6 53.0747 24.9738 1.38132 -1.86355 2.7084 19.7503 +5899 4 52.7154 24.2509 0.898374 -13.0694 -24.4059 -9.99565 +5900 4 53.2522 25.5795 0.686793 9.94881 23.634 -11.856 +5901 6 26.1984 24.7352 0.509304 -7.53082 -0.727442 -26.3589 +5902 4 25.609 24.783 41.6367 17.1237 -12.5609 6.929 +5903 4 25.7967 25.3842 1.06587 -1.32139 13.3231 25.2347 +5904 6 23.0109 2.41889 11.5345 -1.81733 -0.917938 -19.7561 +5905 4 22.156 2.16845 11.9124 1.98231 0.963836 1.10425 +5906 4 22.831 2.471 10.5696 1.38956 0.195961 11.1121 +5907 6 29.9165 12.8947 31.0013 41.0722 8.15666 -12.068 +5908 4 30.8272 12.8901 31.3843 -23.6061 -3.22469 3.62361 +5909 4 30.1671 13.0589 30.0659 -21.5099 -4.3955 11.2257 +5910 6 24.0423 16.1922 40.3682 -11.7161 -52.7791 -12.7633 +5911 4 23.7963 16.7427 41.0863 -4.03022 37.1909 22.8519 +5912 4 24.4513 16.6836 39.6566 3.29428 17.0417 2.56802 +5913 6 21.8759 29.9137 12.7377 16.7673 9.38207 5.68416 +5914 4 21.0615 29.603 12.3447 -12.732 2.54077 -5.12984 +5915 4 21.8572 30.8889 12.7388 -3.49843 -10.2696 0.0943897 +5916 6 45.2049 12.2865 6.6319 2.92472 30.2037 5.62675 +5917 4 45.4908 11.5347 6.14771 0.0808414 -27.1796 -10.0093 +5918 4 45.9331 12.9133 6.49804 -8.49251 3.31449 4.74769 +5919 6 7.58748 25.3948 38.035 37.4402 -5.69153 16.1754 +5920 4 8.20159 25.1941 37.2709 -20.479 6.14302 24.9331 +5921 4 8.13335 25.2556 38.8857 -20.6102 5.92378 -35.7711 +5922 6 46.1732 7.83303 16.6988 4.4841 14.5494 -17.535 +5923 4 46.5452 7.84101 15.8027 -9.24205 10.2202 -0.760543 +5924 4 46.6945 7.14485 17.0776 9.771 -19.5689 22.069 +5925 6 54.9675 12.85 7.71106 -14.5426 11.3809 9.40253 +5926 4 54.9732 13.8139 7.75484 8.59467 -0.566973 -8.90089 +5927 4 54.3786 12.658 8.45528 8.25441 -10.7611 -5.52346 +5928 6 26.93 39.6729 37.1759 35.4319 -17.0193 24.0328 +5929 4 27.7049 39.4447 36.6239 -16.3058 8.04164 -6.8945 +5930 4 27.2164 39.2553 38.0316 -23.1866 12.5553 -17.3208 +5931 6 27.0277 8.92497 38.0115 25.8258 -15.1538 -19.4143 +5932 4 26.3205 9.53863 38.1727 -14.2244 17.8778 -0.0983549 +5933 4 27.5327 9.26244 37.2322 -14.307 -2.33761 14.5508 +5934 6 8.04621 7.65921 29.9125 5.96085 -8.8046 12.0925 +5935 4 8.66182 7.92407 30.6202 -6.26406 -0.422529 -8.96361 +5936 4 7.80891 8.46925 29.4702 -0.676119 14.2 -7.80782 +5937 6 27.8751 27.8625 12.1001 -31.3933 22.4686 19.454 +5938 4 27.5095 28.719 12.4446 7.36494 -19.3603 -4.77408 +5939 4 28.6439 28.079 11.5991 25.5597 3.40516 -15.3306 +5940 6 23.5464 30.4867 38.1533 -1.61625 -6.62341 9.61758 +5941 4 24.0833 30.8354 38.8715 -5.37174 -4.61911 9.80189 +5942 4 23.9933 30.8636 37.4157 3.53805 3.96797 -22.0348 +5943 6 48.0805 24.2983 17.323 -13.282 16.609 -1.2587 +5944 4 47.4189 24.8263 17.8481 20.4082 -10.1323 -14.146 +5945 4 48.1392 24.7467 16.448 -1.93384 -6.90404 13.1726 +5946 6 38.5137 5.30503 40.3397 -7.95418 19.3032 15.6478 +5947 4 38.8605 4.51762 39.8919 14.9068 5.60332 0.485922 +5948 4 39.0782 6.12858 40.3573 -2.94219 -25.5867 -8.28862 +5949 6 31.2334 3.92786 33.7298 9.31662 9.08835 -13.8199 +5950 4 31.8178 4.24357 33.0198 -6.00608 1.6224 5.38661 +5951 4 31.5957 3.05883 33.9262 -1.57661 -10.2527 7.73336 +5952 6 41.2417 8.81323 38.1247 -0.484904 -12.0607 11.4744 +5953 4 40.9476 8.42023 38.9721 -0.376638 9.54125 -7.13918 +5954 4 41.2604 9.77162 38.2616 1.58028 -2.03482 4.89657 +5955 6 53.3602 29.1001 24.587 -11.0956 7.72569 2.80506 +5956 4 52.5731 28.5594 24.8544 13.5868 20.3826 -7.54714 +5957 4 53.0545 29.9696 24.221 1.09296 -21.6534 7.27768 +5958 6 54.9204 15.5334 40.7094 -9.73888 -15.8123 9.62316 +5959 4 54.8689 16.4143 40.4003 18.499 35.235 -15.9181 +5960 4 53.9936 15.418 40.9228 -4.36807 -19.1537 6.40504 +5961 6 46.4046 17.0769 31.8825 -4.88415 8.61979 -0.317809 +5962 4 46.5643 17.9902 31.5503 -4.54791 -14.0743 0.407713 +5963 4 45.6863 16.6828 31.3336 12.87 12.2001 8.08584 +5964 6 36.9136 25.0502 23.0508 4.56287 5.14957 -21.3849 +5965 4 37.1181 25.0639 23.9643 8.53293 7.7605 31.6671 +5966 4 36.2092 24.4176 22.9617 -10.0712 -5.98832 -5.36051 +5967 6 11.3786 4.43396 15.9309 9.37238 17.2608 -3.05203 +5968 4 11.3458 3.5794 15.4688 2.43716 9.1998 0.97888 +5969 4 11.7026 5.12247 15.2999 -5.70859 -16.4138 5.77914 +5970 6 12.7896 7.06818 19.4525 -2.66824 36.6483 10.7184 +5971 4 12.9865 6.29411 18.9417 0.495259 -24.323 -4.17525 +5972 4 12.2519 6.828 20.2299 7.04203 -8.59773 -13.3487 +5973 6 12.0617 33.6499 17.5439 8.15138 -13.8576 -23.5514 +5974 4 11.882 34.0654 18.3682 -11.1792 16.7137 24.4072 +5975 4 12.5902 32.8825 17.8108 -1.08307 -0.300652 -3.52071 +5976 6 10.2421 4.75805 2.56564 19.3085 -11.8452 1.86691 +5977 4 9.45693 4.42703 2.99801 -10.4664 -1.42643 2.59081 +5978 4 10.9264 4.04527 2.68225 -6.18235 16.1727 -3.70264 +5979 6 4.57251 36.8735 12.1563 3.74049 -23.6741 -21.1206 +5980 4 4.47996 37.7154 12.5491 -11.9533 34.2042 20.255 +5981 4 5.43811 36.9355 11.7449 0.921031 -10.3689 -0.351167 +5982 6 30.7412 35.3317 25.8213 -33.1423 -23.543 6.44877 +5983 4 31.2776 35.279 26.6136 10.5944 3.70967 -1.00248 +5984 4 29.9668 34.7615 26.0677 13.1622 11.7399 -12.7178 +5985 6 20.1808 7.16217 1.863 30.1084 16.4868 -11.867 +5986 4 20.9002 6.54767 2.16414 -16.0511 17.5979 -8.58506 +5987 4 20.6676 7.94845 1.45686 -14.4541 -29.1822 13.3394 +5988 6 21.7608 6.89709 28.9964 -11.5861 -1.80466 -8.03013 +5989 4 22.036 7.16072 29.8728 6.26891 1.69864 13.9065 +5990 4 22.5393 6.5849 28.5353 8.83449 0.101288 -1.59126 +5991 6 6.87368 37.1369 6.9386 0.0966708 26.3677 27.0276 +5992 4 7.29364 38.0249 6.81033 -7.58004 -19.2864 -7.26696 +5993 4 6.61926 37.1727 7.88431 1.83825 -7.02501 -19.6681 +5994 6 37.1919 18.383 16.2937 29.0289 34.5069 -53.2335 +5995 4 36.6258 18.6038 17.011 -19.1901 14.6481 22.2869 +5996 4 37.3395 19.2625 15.7718 -11.4936 -34.1346 27.3139 +5997 6 52.3871 25.4845 31.3088 43.0013 26.9533 24.6388 +5998 4 52.3889 26.4071 31.692 -12.9868 -26.5619 -15.078 +5999 4 53.3562 25.2868 31.368 -25.5563 -9.18093 -7.26498 +6000 6 3.9438 39.8542 16.3866 5.1752 -27.5036 1.27902 +6001 4 3.12325 39.6837 16.8533 -2.95342 6.97088 0.658243 +6002 4 4.2268 38.9387 16.1321 1.7457 31.291 -0.663648 +6003 6 26.0576 14.6358 18.3044 5.96149 26.4073 -5.45028 +6004 4 27.0205 14.6227 18.4365 -6.17521 2.0803 0.6884 +6005 4 25.8163 15.5963 18.2277 1.60591 -22.5499 1.70317 +6006 6 22.193 39.6312 23.63 -9.05536 -28.9999 9.83005 +6007 4 22.6639 40.3889 23.3083 10.2118 22.7493 1.36107 +6008 4 21.7625 39.8434 24.4837 8.53947 8.47814 -10.8223 +6009 6 5.99591 12.8758 22.3742 5.3436 -0.661706 -0.190442 +6010 4 6.14325 13.1833 21.4713 -0.679137 1.38292 -0.893953 +6011 4 6.87425 12.6139 22.6767 3.78948 -2.07704 1.05968 +6012 6 48.9338 28.1628 34.7078 -35.8712 26.2385 4.15493 +6013 4 48.201 27.5556 34.4701 19.6025 -0.265843 1.21851 +6014 4 49.8217 27.8183 34.7001 12.2446 -20.4038 -3.75147 +6015 6 7.76997 22.4407 33.2353 -5.03116 -11.9457 7.57841 +6016 4 8.01899 22.0009 34.0594 5.33952 7.11928 -2.86974 +6017 4 7.10669 21.8538 32.8613 -1.17853 4.26119 -2.40878 +6018 6 41.0955 39.6222 11.7091 10.6381 -27.5326 3.52715 +6019 4 40.5189 40.2602 11.288 0.0449404 21.7474 -0.525631 +6020 4 41.8612 39.9918 12.1934 -14.1016 15.1893 -9.59654 +6021 6 26.8828 37.915 39.359 -2.28209 0.567193 11.8658 +6022 4 27.0774 38.1179 40.3058 -8.7685 -4.90824 -13.677 +6023 4 25.9807 37.5277 39.3071 12.6176 5.79057 5.20946 +6024 6 16.8333 41.5427 16.7885 -17.5694 -7.84814 -1.75502 +6025 4 17.5277 0.148354 16.3589 5.69783 -2.62712 11.3029 +6026 4 16.9979 41.3393 17.726 8.37907 5.88226 -10.2657 +6027 6 19.018 8.99657 17.6669 -0.857073 -13.2853 32.8939 +6028 4 18.786 9.90902 17.9004 1.19423 -0.949069 -3.8378 +6029 4 19.1413 8.47286 18.5173 -2.13518 15.132 -32.6231 +6030 6 31.1034 24.3848 20.0884 -4.53251 11.7336 -2.81937 +6031 4 30.5766 24.6463 20.8643 6.13742 -4.20791 -6.36966 +6032 4 31.7352 25.0989 19.9557 0.422515 0.146513 0.562515 +6033 6 24.595 6.30881 27.6069 -9.90555 -11.0232 -14.6341 +6034 4 24.6965 6.6392 26.7007 0.89989 8.76246 8.56835 +6035 4 24.5083 5.35606 27.4824 0.344086 -1.65377 9.53776 +6036 6 11.6335 5.32908 8.21523 29.3959 14.5761 -12.3078 +6037 4 10.744 5.12885 8.4339 -32.4949 -9.42488 11.9016 +6038 4 11.5648 6.10082 7.62627 0.276207 -9.77668 5.48929 +6039 6 16.478 34.2375 17.2464 48.0037 -1.61779 7.84119 +6040 4 15.7306 34.6529 16.8034 2.48832 11.605 -8.49411 +6041 4 17.405 34.6677 17.061 -56.7063 -17.2336 2.19282 +6042 6 40.7477 40.4696 8.51561 8.11488 -8.65224 -15.2287 +6043 4 40.0224 40.6832 9.09702 -8.50867 2.70994 6.70857 +6044 4 40.4514 39.6579 8.0617 2.3787 8.8385 5.97324 +6045 6 42.7444 5.87231 14.2984 24.2128 7.61876 -1.56509 +6046 4 42.0757 5.96647 14.9632 -14.4615 -1.80987 8.42029 +6047 4 42.482 5.17586 13.6922 -11.2697 -3.69634 -0.0191913 +6048 6 14.3614 21.0573 6.06698 -40.3301 2.02826 20.3099 +6049 4 14.5082 21.6099 6.85229 1.25225 -5.13952 -5.68983 +6050 4 15.1941 20.9025 5.67555 35.2665 -1.55979 -15.977 +6051 6 16.3015 37.7733 18.121 -25.7671 9.10936 -15.4408 +6052 4 15.381 38.1761 18.2458 41.2545 -15.1679 7.93486 +6053 4 16.7788 37.6858 18.9587 -11.1023 5.71932 1.62274 +6054 6 40.7984 27.7161 27.1129 -11.0179 0.499807 -0.336913 +6055 4 41.4742 27.2927 27.66 5.56711 1.79851 -1.75817 +6056 4 41.2133 28.334 26.4954 6.67104 -1.0644 4.19578 +6057 6 44.9561 25.991 14.0487 25.7727 -16.7938 -19.0088 +6058 4 45.3739 25.1637 13.7108 -16.5098 12.8855 15.8726 +6059 4 45.5476 26.6442 13.6478 -7.0093 2.51014 3.36733 +6060 6 2.61494 33.9473 21.2474 -9.6198 2.06317 -4.83635 +6061 4 2.13704 34.7904 21.3802 4.44423 -7.12162 -0.559399 +6062 4 2.10703 33.4352 20.5879 2.52794 8.8644 7.26413 +6063 6 5.77575 4.45209 12.8318 1.03208 18.7287 8.08797 +6064 4 5.35339 3.69685 13.2518 -3.06112 -10.1665 -2.69945 +6065 4 5.8052 5.15326 13.507 0.887863 -7.02627 -5.52828 +6066 6 16.8649 5.92112 7.40874 19.9951 -5.29142 4.66315 +6067 4 16.4994 5.07825 7.12483 -4.58221 -9.71617 -5.56506 +6068 4 16.109 6.48147 7.52662 -16.4719 8.95214 3.19539 +6069 6 17.8298 38.4233 36.8534 9.258 40.3096 -0.310058 +6070 4 17.7926 39.4131 36.8935 -6.04129 -19.7424 1.84578 +6071 4 18.5177 38.2893 36.201 1.93535 -10.8086 -1.92368 +6072 6 43.3019 20.5959 5.44166 -6.9278 5.85438 -3.52603 +6073 4 43.1055 21.501 5.07158 -2.97833 -26.833 8.04502 +6074 4 42.4661 20.0651 5.41852 11.3272 16.2867 -2.99003 +6075 6 21.5372 23.2991 30.4448 -14.935 11.2275 -26.3705 +6076 4 20.9947 23.0537 31.1809 -7.12546 -6.28648 20.8256 +6077 4 20.8648 23.582 29.7655 22.6032 -4.28693 10.3415 +6078 6 0.251317 28.0486 36.1651 -22.0243 21.0356 -19.5016 +6079 4 1.02049 27.7114 36.6113 18.9729 -1.47718 6.47801 +6080 4 0.506474 28.8456 35.6445 2.58205 -12.8812 9.00708 +6081 6 3.04678 17.0589 11.5707 1.23946 -7.00965 -18.5436 +6082 4 3.14519 17.2619 12.4977 -1.89892 8.1653 13.6088 +6083 4 2.54959 17.7766 11.1613 1.73961 1.36316 5.23635 +6084 6 24.1645 37.0333 23.9496 -13.0802 10.7124 17.6799 +6085 4 23.6099 37.8384 23.8849 6.1763 -9.33563 -1.28122 +6086 4 24.4663 37.0147 24.8893 -3.58635 -1.49958 -18.3056 +6087 6 3.94341 20.5209 27.4789 6.12038 36.4957 26.1587 +6088 4 3.64002 20.0757 26.7101 -13.0247 -10.3927 -30.3524 +6089 4 3.8213 21.4921 27.3096 0.6263 -21.942 -1.90407 +6090 6 54.8381 2.78983 29.6272 25.3782 12.002 29.7256 +6091 4 54.8259 2.49183 30.5832 -3.08894 8.50949 -25.0172 +6092 4 0.681738 3.33643 29.5869 -23.0163 -14.7319 0.890579 +6093 6 27.1738 8.43221 31.7209 4.37325 44.8318 10.1666 +6094 4 26.7765 8.21235 30.8513 3.34031 12.9925 0.247925 +6095 4 27.4394 9.43578 31.8184 -18.7706 -51.1708 -12.8964 +6096 6 30.9422 1.62815 30.3909 7.68258 9.19266 14.5116 +6097 4 30.6848 0.902997 29.8247 -17.6873 -14.6962 -9.63211 +6098 4 30.1385 1.96768 30.8202 -2.70664 -9.08975 -4.26502 +6099 6 26.4126 36.4396 36.8407 14.7094 2.78685 2.16538 +6100 4 26.1754 35.936 36.0621 -1.37556 -1.6634 -9.1832 +6101 4 27.3614 36.6667 36.7609 -11.9856 -2.56278 0.470716 +6102 6 51.3051 10.055 21.7064 16.9271 -12.7171 -0.47742 +6103 4 50.71 9.38094 22.0984 13.3581 11.7028 -6.50503 +6104 4 52.1297 9.58932 21.3894 -28.6693 12.5934 9.83408 +6105 6 52.4269 12.3712 23.2743 -6.4707 23.0639 13.1163 +6106 4 51.7645 13.1043 23.2119 13.6159 -11.3613 1.42096 +6107 4 52.024 11.6223 22.842 -6.69009 -13.0182 -9.76131 +6108 6 10.0084 38.37 20.6075 21.9453 -2.41338 -4.30271 +6109 4 9.45069 38.2813 21.3825 -6.19229 -0.201962 6.85596 +6110 4 10.9137 38.1225 20.8794 -8.5598 0.614521 -3.9406 +6111 6 22.7031 33.2664 0.640708 10.9794 6.62646 4.85135 +6112 4 23.6679 33.2996 0.582378 1.56947 7.5672 2.73741 +6113 4 22.5144 32.4288 0.230474 -14.5468 -15.5809 -6.04383 +6114 6 14.0917 40.8812 25.4864 9.18744 8.89463 -14.7226 +6115 4 14.196 40.6884 26.4283 -5.63746 -5.20078 0.271339 +6116 4 13.2439 40.5125 25.1796 5.27736 1.6069 9.18822 +6117 6 42.7681 15.0783 14.9763 7.15748 5.71054 -2.59845 +6118 4 43.0785 15.7158 14.2901 -5.10451 -16.9901 16.8665 +6119 4 41.8327 15.2592 15.1092 -5.54173 -0.124331 1.80857 +6120 6 30.2406 7.22111 8.53832 -0.545825 26.9265 -4.64375 +6121 4 30.1758 8.19473 8.52708 -1.1145 -9.52086 -16.9196 +6122 4 30.4024 7.07989 9.45321 5.06633 -17.0605 24.2519 +6123 6 3.37759 19.8423 41.3077 23.4194 0.89426 -0.123069 +6124 4 3.19865 19.3681 40.4829 0.842743 3.23829 1.04749 +6125 4 4.34953 20.0012 41.2688 -20.407 -4.57585 2.1738 +6126 6 8.87423 25.1354 17.2017 -10.0567 -4.23249 -18.7298 +6127 4 8.96932 24.947 16.2256 5.94886 2.92938 28.6011 +6128 4 9.65182 24.8278 17.6915 0.0257745 -5.63434 -9.64419 +6129 6 9.32494 14.9555 22.0283 -12.5325 4.5599 7.62514 +6130 4 9.01993 14.8718 22.9489 -0.27625 1.365 -7.1979 +6131 4 10.1958 14.5523 22.0148 2.38734 -2.44115 -2.54227 +6132 6 2.03086 4.7751 20.8592 -0.302533 -25.5342 -8.8148 +6133 4 2.76807 5.37577 20.9697 7.90436 11.3601 5.00545 +6134 4 1.2576 5.15949 21.2703 -7.54078 11.376 6.7073 +6135 6 18.2964 7.06718 3.86051 -0.633466 1.54328 39.8902 +6136 4 18.916 7.22135 3.16498 20.2468 5.35447 -22.1173 +6137 4 18.8081 6.54637 4.52758 -12.8964 10.087 -8.61721 +6138 6 17.0178 19.1734 19.8425 8.05121 8.342 4.19715 +6139 4 17.786 18.9037 19.3194 -9.06534 -4.96345 -2.22737 +6140 4 16.269 18.585 19.6427 11.1227 0.819232 -3.01639 +6141 6 4.30363 6.55267 21.3463 7.67654 -0.43578 -3.38259 +6142 4 4.33009 7.06923 20.5107 4.36212 -5.74714 10.2686 +6143 4 5.22777 6.26626 21.5669 -20.6993 9.2157 -12.5452 +6144 6 20.7848 36.9284 35.662 4.03453 1.95325 3.7669 +6145 4 20.2254 37.0836 34.8976 -2.25577 1.87165 -3.27163 +6146 4 20.2383 36.4327 36.2875 0.848364 -0.11832 4.44878 +6147 6 4.7306 15.0205 31.2333 -1.91968 -20.8619 8.65585 +6148 4 4.4229 14.7734 32.1398 6.18773 10.2906 -17.1472 +6149 4 4.73385 15.973 31.1263 -2.35963 8.87481 4.31723 +6150 6 2.35358 1.22877 17.5767 10.9459 -8.92502 -6.22121 +6151 4 3.05741 1.28614 16.8672 -19.772 5.07478 19.7417 +6152 4 1.94409 2.09607 17.7592 7.86728 -5.07336 -5.26938 +6153 6 34.6221 31.5613 19.8029 0.0167231 -1.91103 -0.857839 +6154 4 35.0026 31.8698 18.9629 1.12657 -3.13716 4.28436 +6155 4 34.4223 32.3623 20.3103 -0.485441 0.265221 -3.01806 +6156 6 24.1912 21.6103 13.5173 31.6251 8.72647 13.7111 +6157 4 25.0921 21.8731 13.8418 -25.6554 -7.43575 -12.369 +6158 4 23.5893 22.1875 13.984 -2.65104 7.77201 2.87587 +6159 6 37.2187 41.0834 5.69361 1.76676 -13.0415 -0.936073 +6160 4 37.8761 41.7354 5.91144 16.7665 3.57334 0.125879 +6161 4 36.4089 41.5349 5.88363 -19.4064 5.82624 -1.33385 +6162 6 8.4323 8.00063 20.2395 28.2224 -17.334 -6.20124 +6163 4 9.29892 8.115 20.6547 2.73811 -3.60152 -0.447724 +6164 4 7.94828 8.69862 20.6224 -29.3938 29.4062 12.6481 +6165 6 14.9357 18.8843 36.7618 11.8158 33.7978 0.271425 +6166 4 14.1259 19.2123 36.362 -3.40669 -6.42507 -0.135577 +6167 4 15.5651 19.6361 36.6422 -7.52364 -17.7077 5.06346 +6168 6 43.9725 40.6444 18.6569 4.16672 -2.33153 16.0012 +6169 4 43.9166 40.834 17.7203 0.682613 4.51617 -13.4207 +6170 4 44.9212 40.6761 18.9032 -12.0211 -3.47257 -3.21486 +6171 6 33.7852 32.2494 37.3449 -11.8504 2.76306 -14.1758 +6172 4 34.0177 32.2775 36.4055 -1.41242 -0.232407 11.1732 +6173 4 34.3686 31.6236 37.7745 10.7747 -2.06792 3.13276 +6174 6 5.09749 29.2901 24.0356 16.7213 -6.5526 19.7529 +6175 4 5.77222 29.487 24.7328 -11.5239 -2.29901 -14.2657 +6176 4 4.7684 30.1321 23.7215 -1.73734 11.0072 -2.10513 +6177 6 33.6153 36.4198 10.9805 1.47517 3.52666 5.33615 +6178 4 32.7579 36.4403 10.5596 -3.06779 3.10292 -7.60642 +6179 4 33.384 36.4828 11.91 5.71512 -0.747971 7.16991 +6180 6 28.3006 33.5952 13.1115 6.62888 -15.4249 13.7129 +6181 4 27.948 33.7778 12.2398 -4.56551 -8.24283 -4.77521 +6182 4 28.1705 32.6462 13.2914 -0.364449 12.3294 -7.26248 +6183 6 6.16378 19.058 24.2919 3.99573 -9.29146 -27.7059 +6184 4 6.01812 19.825 24.8144 -3.49512 27.1397 16.8881 +6185 4 6.29927 18.3335 24.8859 3.7649 -20.2974 16.0908 +6186 6 28.4267 19.9356 1.8581 6.30761 1.98196 1.30153 +6187 4 28.5945 19.3745 1.10227 -2.74725 -9.675 -9.29711 +6188 4 29.2893 20.1184 2.23075 1.76934 5.71608 2.57016 +6189 6 42.0557 23.969 9.55925 -0.174378 -1.97525 4.49576 +6190 4 42.3037 23.8044 10.4694 5.92504 9.79373 11.5418 +6191 4 41.7282 23.1152 9.29053 -8.19873 -12.6145 -11.7634 +6192 6 43.5187 7.30226 27.4319 7.08124 -12.3985 0.368771 +6193 4 42.7424 7.14751 27.9838 -5.23639 1.01312 3.8871 +6194 4 43.2552 7.97753 26.8025 -4.71413 8.37143 -8.21745 +6195 6 20.4824 33.0041 9.27291 -32.573 -27.3267 34.6611 +6196 4 19.7824 32.5876 9.93875 35.2414 32.5831 -36.6535 +6197 4 20.3431 33.9616 9.1663 -10.2228 -2.75758 9.24016 +6198 6 38.0326 35.2526 15.9362 -7.94884 -19.6622 -5.99631 +6199 4 37.3459 34.9971 15.2894 4.63074 2.95951 5.93375 +6200 4 37.9463 34.6017 16.6504 2.45283 5.99568 -2.76115 +6201 6 47.5301 20.8853 3.96175 -5.34824 -5.66637 20.3565 +6202 4 47.9759 21.3648 3.2498 -4.9297 7.97101 8.48596 +6203 4 47.5029 21.3928 4.81786 6.75175 -1.3172 -26.6206 +6204 6 10.9933 31.6966 41.4271 11.47 5.02521 -0.853614 +6205 4 11.6392 31.7665 40.7132 0.112137 -5.28149 3.10577 +6206 4 10.1353 31.6993 40.998 -8.62143 -0.203152 -1.66696 +6207 6 43.2403 12.6562 2.57215 9.62694 -8.68348 -18.5989 +6208 4 42.9077 12.993 3.39384 -2.38679 2.43178 19.528 +6209 4 44.033 12.1261 2.78242 -8.9232 8.2725 3.71991 +6210 6 49.4204 25.4105 21.1683 5.59269 -12.2048 -2.72561 +6211 4 50.0196 25.2987 20.4097 -7.64964 4.29225 2.01473 +6212 4 48.8877 24.5919 21.195 1.69169 7.44836 1.02425 +6213 6 1.95674 34.1403 26.4747 8.8762 -24.2704 6.47661 +6214 4 2.77674 33.6103 26.5537 -12.4269 14.6955 -4.62849 +6215 4 1.26657 33.4613 26.3994 -1.21739 9.31774 -1.03397 +6216 6 17.1306 20.8229 36.6851 -31.9931 14.1441 13.8122 +6217 4 16.9533 21.7471 36.9985 5.62896 -19.6931 -5.93312 +6218 4 18.0634 20.696 36.5868 23.783 -2.64609 -3.70934 +6219 6 36.6048 10.9866 3.71548 -5.44552 8.31799 24.2539 +6220 4 35.7423 11.3886 3.87785 -5.6936 5.55042 -13.8219 +6221 4 36.8135 10.7077 4.61447 10.9535 -7.59336 -0.361553 +6222 6 14.2169 20.6838 21.9439 11.6961 23.12 -6.3106 +6223 4 13.8085 20.2376 21.1912 1.98746 8.13024 -7.83415 +6224 4 14.8103 21.4259 21.6461 -14.674 -27.097 -1.82439 +6225 6 33.9151 12.2544 9.54899 39.8857 -26.0408 -21.0892 +6226 4 34.3088 11.5163 10.0208 11.0461 -3.70138 -11.6499 +6227 4 33.2997 12.4814 10.1903 -47.9458 31.9244 32.2008 +6228 6 21.8056 41.4836 2.15686 0.64336 -1.87746 -8.80618 +6229 4 22.0354 41.6672 1.22189 -5.57638 1.91412 12.8342 +6230 4 22.5122 40.9391 2.50884 5.16687 -0.375256 0.644554 +6231 6 20.9282 10.4547 14.1996 25.019 -0.0729632 25.5582 +6232 4 21.5922 10.842 14.8375 -21.0894 -6.80718 -21.5316 +6233 4 20.826 9.54084 14.5456 -0.887825 12.9084 -9.51249 +6234 6 6.24616 4.45231 24.6293 -10.9468 0.993291 2.39826 +6235 4 6.83688 4.17894 23.9311 12.242 -0.137787 -14.9911 +6236 4 5.68087 3.68408 24.7586 -3.59028 -1.51582 -1.5433 +6237 6 50.784 14.5954 23.4824 21.8736 9.84292 5.60122 +6238 4 51.2681 15.1205 24.1582 -9.03857 -7.6656 -10.4761 +6239 4 49.9341 14.3608 23.8519 -7.60536 -4.54693 6.65168 +6240 6 52.7678 13.9144 9.68214 -3.90955 36.1598 -0.40974 +6241 4 52.8738 13.0144 9.92216 4.47335 -34.5538 7.53363 +6242 4 51.8729 14.0092 9.35938 -14.036 0.105332 -6.17221 +6243 6 9.05048 2.05234 29.9152 -29.3842 -12.1538 -14.6176 +6244 4 9.42756 2.83336 30.2687 13.3628 24.1087 13.7335 +6245 4 8.09173 2.26823 29.8032 18.9866 -6.39081 0.174186 +6246 6 7.13499 29.9757 26.2377 7.52656 -33.046 2.78556 +6247 4 6.52748 30.39 26.8607 -0.20976 -1.88395 4.87081 +6248 4 7.49713 29.1538 26.6869 -11.4544 24.9502 -11.4644 +6249 6 49.1541 41.742 14.3355 11.4439 21.5488 -10.6063 +6250 4 49.5333 41.2573 13.5835 -2.72613 -5.13007 3.47372 +6251 4 49.526 0.750494 14.2401 -8.50163 -23.9907 2.80869 +6252 6 5.64545 3.82333 19.1929 -5.43924 -10.1162 19.2647 +6253 4 5.12472 3.39384 19.906 6.51959 7.46947 -11.8792 +6254 4 5.07872 3.8651 18.4273 -3.31865 2.78603 -7.74707 +6255 6 9.32747 35.8381 24.9081 -3.67476 7.0144 6.61099 +6256 4 10.2167 35.7622 24.5243 -1.5306 1.39279 3.84516 +6257 4 9.42305 36.4736 25.6393 1.10498 -0.920313 -3.33942 +6258 6 53.0258 29.7567 11.5493 -1.29773 -2.97991 8.71205 +6259 4 53.4398 30.4104 10.9769 2.6525 4.63524 -3.89524 +6260 4 52.8324 30.2122 12.386 1.27544 -1.91261 -4.55584 +6261 6 22.6082 9.97702 5.69106 1.45951 -2.04334 43.7981 +6262 4 23.4598 10.2484 6.09617 -7.85329 -3.83944 -13.5574 +6263 4 22.5497 10.2693 4.79236 2.60512 5.60546 -21.7219 +6264 6 39.5532 19.6216 2.68726 -3.50035 -14.5445 -22.3968 +6265 4 38.6563 19.3067 2.54039 -1.65167 0.121811 17.9309 +6266 4 39.9003 19.405 1.80953 18.3116 7.78412 6.67062 +6267 6 45.082 35.5833 7.81025 20.3465 -2.3491 -25.2688 +6268 4 45.1219 36.3229 8.40611 -5.73741 11.9797 15.8104 +6269 4 44.452 34.9332 8.12016 -12.4923 -3.86067 9.83054 +6270 6 29.7976 14.244 9.96067 -5.32248 -4.64296 1.12628 +6271 4 30.0443 14.0971 9.02808 -4.18819 -1.64606 2.67632 +6272 4 28.8444 14.0269 10.0606 18.5465 4.64021 -4.02524 +6273 6 29.2523 30.155 21.8932 -5.77992 6.30922 3.94049 +6274 4 29.1431 30.8143 21.21 -7.42967 10.4849 -3.0507 +6275 4 30.0153 29.6632 21.6201 11.6336 -14.2167 -2.13367 +6276 6 11.1107 18.8213 6.56056 -14.6836 -1.88929 0.635516 +6277 4 11.166 19.7501 6.27543 7.98891 -2.6539 -0.194038 +6278 4 11.9915 18.4225 6.59495 6.41359 9.14832 -2.51569 +6279 6 13.4142 39.1371 13.4638 17.7807 -10.3765 -23.6259 +6280 4 13.7831 39.7975 14.0449 5.16656 9.87024 9.85065 +6281 4 12.6066 38.8468 13.8734 -16.0883 -5.26763 6.93978 +6282 6 50.1521 12.9948 0.13749 23.7903 11.3983 42.7862 +6283 4 49.8531 12.6437 41.2486 -17.3674 -16.2897 -43.7514 +6284 4 50.6811 12.2823 0.528204 -2.61001 5.26075 1.59628 +6285 6 47.8279 31.3538 27.7873 0.535952 -14.579 -21.2406 +6286 4 47.8981 31.8966 28.5732 -11.876 9.28639 5.42067 +6287 4 46.9879 31.5201 27.3031 12.1261 3.81279 14.9113 +6288 6 27.708 1.63283 7.49454 14.1634 -3.44528 -21.3886 +6289 4 26.9442 1.71926 8.04828 -16.4795 3.87106 10.0363 +6290 4 27.4331 1.03137 6.77318 -2.44435 3.14912 6.58235 +6291 6 54.8843 20.7912 16.041 -0.591057 -23.5277 -19.4313 +6292 4 54.9506 20.9946 16.9763 2.49267 -3.51754 11.2958 +6293 4 0.215527 19.8591 15.8725 -6.64294 24.8159 10.1677 +6294 6 37.4309 32.9919 34.4461 -3.01999 17.5498 0.613574 +6295 4 37.2599 32.074 34.6492 -8.98721 -14.1314 1.69718 +6296 4 36.602 33.3843 34.0789 10.8556 -9.90957 7.57788 +6297 6 19.516 39.775 6.74949 1.2991 -23.719 -0.568837 +6298 4 19.1628 39.2461 5.9771 11.6696 10.1577 21.4746 +6299 4 19.8715 39.1258 7.41882 -10.6166 14.587 -19.1486 +6300 6 32.439 2.74298 8.0597 2.15016 14.1028 28.0311 +6301 4 32.8474 3.04427 8.91221 -2.20578 -4.83758 -21.9226 +6302 4 31.6043 2.37221 8.38063 -2.27075 -4.50389 -9.9889 +6303 6 12.9757 16.0783 4.05517 0.782156 -17.4841 -11.0101 +6304 4 12.5393 15.6612 4.81952 2.97976 0.136191 -5.67644 +6305 4 13.3707 15.3387 3.55371 -3.64889 7.0956 8.52646 +6306 6 4.65115 29.9533 5.41887 4.80886 14.2508 -32.4371 +6307 4 5.0407 30.2031 4.52094 -17.5959 -12.1853 28.663 +6308 4 3.95879 29.263 5.26663 23.43 17.9812 0.878069 +6309 6 29.754 32.1152 24.0535 7.2798 7.01713 3.37681 +6310 4 30.6602 32.1649 24.4187 -11.1956 -0.828668 -6.39664 +6311 4 29.7572 31.4388 23.3746 -2.03067 -7.97912 -3.55015 +6312 6 11.8649 30.6972 33.4692 4.66278 -43.8766 26.3819 +6313 4 11.8723 29.8544 34.0435 -6.78391 38.5593 -23.2698 +6314 4 12.7601 30.7129 33.1118 -0.162199 2.5806 0.32685 +6315 6 17.3589 40.4121 27.3072 22.6925 26.1242 -9.80885 +6316 4 17.3318 41.3765 27.4299 10.8839 -2.3351 -5.50809 +6317 4 16.5554 40.1462 27.6883 -41.5002 -17.3681 16.6281 +6318 6 8.67113 4.89706 8.92484 12.0335 -9.87957 -4.1983 +6319 4 8.33733 5.39218 8.1724 -5.0195 2.6367 -1.72337 +6320 4 8.22391 5.22927 9.70847 -2.49168 4.71619 2.25155 +6321 6 39.5722 17.6819 9.57834 18.7012 -23.4437 -36.958 +6322 4 39.2207 17.6668 10.4653 -7.32211 -9.11094 11.7967 +6323 4 39.6226 16.7555 9.16114 -8.90732 35.1542 21.3272 +6324 6 31.4906 30.1663 28.5669 -18.2413 -3.40307 10.1233 +6325 4 32.2933 30.4252 28.099 2.93126 -8.695 5.25695 +6326 4 31.6493 29.3506 29.0723 8.50077 6.58979 -7.17605 +6327 6 52.667 19.2904 40.0609 -3.10376 4.72625 -3.48654 +6328 4 52.9542 18.5867 39.4362 -2.88314 13.2503 8.01058 +6329 4 53.0181 20.1618 39.7754 -0.243354 -8.89628 -7.05583 +6330 6 3.24103 7.80987 9.85575 15.4795 13.9798 -0.387217 +6331 4 3.75934 8.59525 10.1836 -13.0283 -21.6848 -11.3123 +6332 4 3.84189 7.30622 9.27659 -5.58147 6.91981 6.81825 +6333 6 23.1336 35.2172 35.587 -21.8844 -14.3383 30.559 +6334 4 23.8289 35.3646 34.9695 18.2116 12.6911 -23.5817 +6335 4 22.438 35.8962 35.5045 5.76256 0.966742 -5.52301 +6336 6 19.4997 14.0668 20.8253 -20.4482 -5.33672 -12.8711 +6337 4 19.9465 14.5101 21.5526 -0.10572 6.16799 9.82761 +6338 4 18.517 14.0876 20.9737 19.1914 1.01522 3.6393 +6339 6 23.6166 15.8675 24.0247 18.6101 -11.8924 -11.0295 +6340 4 23.7056 16.8159 24.0204 -5.88143 19.7526 4.0278 +6341 4 24.4592 15.5679 23.6279 -14.5441 0.474754 5.50536 +6342 6 0.271665 30.4941 6.10208 19.3679 10.4089 38.3983 +6343 4 55.0639 30.1609 5.24948 -13.9023 -9.5098 -30.2095 +6344 4 54.47 30.83 6.54681 -8.02886 -2.57547 -7.81581 +6345 6 4.88814 13.205 29.1223 -11.8587 -43.2127 -22.2411 +6346 4 4.78002 13.8458 29.7909 -3.08187 32.2273 31.1649 +6347 4 5.63816 13.4614 28.593 12.4558 6.3486 -8.85318 +6348 6 54.2078 27.2696 19.1963 -15.9712 -23.151 25.2067 +6349 4 0.0774591 27.3551 19.591 11.6552 0.895327 2.86932 +6350 4 54.2345 27.7605 18.3958 2.66703 17.7524 -27.3595 +6351 6 13.918 35.7451 9.18145 -1.78919 -38.7722 -17.1362 +6352 4 13.6805 34.9997 8.54227 8.11159 28.2534 18.027 +6353 4 13.9675 36.5302 8.63631 -0.993585 8.08981 -9.4946 +6354 6 5.91273 31.9181 18.8024 -12.4461 1.37758 17.74 +6355 4 5.51416 32.8097 18.9023 4.86685 -6.68339 -12.1033 +6356 4 6.30341 31.7597 17.9414 -1.0189 10.0948 -10.5031 +6357 6 5.79665 28.8753 9.48388 1.22923 1.68801 -9.18455 +6358 4 5.13151 29.3325 10.0083 -4.81051 1.68465 1.48607 +6359 4 5.29369 28.2634 8.9143 2.26517 5.17431 2.85494 +6360 6 40.1173 6.05944 9.72118 13.8961 -11.6659 -14.1698 +6361 4 40.0092 6.65032 8.94634 5.33155 -13.6 11.5113 +6362 4 40.8322 5.39707 9.49335 -23.1878 23.6737 0.508505 +6363 6 20.33 13.449 41.3936 11.1096 -0.534149 -19.18 +6364 4 21.2311 13.7006 41.7531 -26.0398 -5.61362 -19.048 +6365 4 20.2547 13.6822 40.4168 8.50391 -3.95591 26.8537 +6366 6 14.4455 21.736 27.3642 10.1345 -2.11962 18.0607 +6367 4 15.3888 21.7922 27.5976 -10.3958 0.0660495 -7.924 +6368 4 14.3649 21.6255 26.4124 4.42937 0.724974 -0.20238 +6369 6 38.7561 1.79551 30.0553 7.9914 -17.3849 -15.575 +6370 4 38.4573 2.01955 30.9195 -8.42419 6.13431 27.6354 +6371 4 38.9299 2.64677 29.6557 3.10695 8.29419 -8.65227 +6372 6 5.60526 10.8558 14.1801 -12.7318 -17.5226 5.68918 +6373 4 4.9397 11.5438 14.0518 -0.153792 0.369728 -2.18729 +6374 4 5.10481 10.0791 14.5379 11.5553 16.0131 -9.09073 +6375 6 45.3957 36.7129 27.9145 12.4213 23.5208 -28.0365 +6376 4 46.0624 36.7782 28.6036 -4.12954 -6.22049 8.27184 +6377 4 45.8092 37.2197 27.1638 -19.7894 -19.9635 17.4029 +6378 6 54.0798 35.0308 20.3994 -2.843 -1.86615 -11.5734 +6379 4 53.8804 34.0877 20.4832 1.52986 -2.36109 -0.337181 +6380 4 53.937 35.2424 19.4598 0.882668 -0.831705 10.9264 +6381 6 42.0694 14.2202 28.4717 21.1483 -3.98018 21.7174 +6382 4 41.9885 13.9669 29.4143 -10.3093 2.59547 -11.4583 +6383 4 43.02 14.3987 28.405 -3.82604 1.35242 -7.96462 +6384 6 34.8498 7.69636 26.7062 10.2576 -3.81921 3.94078 +6385 4 35.6291 7.30563 27.124 0.895866 5.46509 7.50645 +6386 4 34.5698 7.0105 26.0965 -7.64543 -1.95318 -6.87837 +6387 6 49.6738 30.7035 23.8555 -19.3272 -4.41511 -13.3992 +6388 4 50.4901 31.166 23.8286 28.3544 13.2291 -0.764283 +6389 4 49.8241 29.9642 24.4268 4.30872 -17.0733 16.2757 +6390 6 50.9008 7.796 14.1645 9.55664 -5.64416 8.78132 +6391 4 50.8079 7.01141 13.6383 2.57079 -23.1487 -4.84087 +6392 4 50.5017 8.45024 13.6177 -13.1237 27.0593 -11.2067 +6393 6 4.26801 39.4668 27.8349 5.05862 -9.29033 0.915363 +6394 4 3.69733 40.2352 27.9464 -2.13812 3.43039 0.251988 +6395 4 3.85787 38.9439 27.1453 -8.48589 -4.99062 -8.23097 +6396 6 8.74801 32.8245 8.20645 -16.3778 -23.5545 -4.64115 +6397 4 8.1587 32.1369 7.77132 15.1044 25.0089 5.08958 +6398 4 8.83862 33.6223 7.65804 -4.44885 -3.27239 -3.39484 +6399 6 52.9644 25.4956 9.38778 -23.0628 41.5097 8.07386 +6400 4 51.9653 25.4466 9.50894 36.2156 4.27363 -7.84863 +6401 4 53.1697 26.4737 9.50477 -8.20239 -39.1491 -3.41364 +6402 6 29.5595 36.7246 19.4744 18.9803 -2.04176 16.4704 +6403 4 29.6949 37.303 18.726 -4.20274 3.37351 -9.90607 +6404 4 30.4598 36.6303 19.854 -15.3589 -5.02994 0.251134 +6405 6 52.32 36.0811 25.1124 8.57954 -21.5781 -32.5589 +6406 4 53.081 35.9362 25.6725 3.50304 3.9365 6.54391 +6407 4 51.6308 36.4579 25.6293 -16.5409 10.2166 18.3955 +6408 6 21.1806 15.7021 31.1799 -1.73968 4.64344 -14.8668 +6409 4 20.7524 16.2958 30.5301 6.89899 -9.15256 14.6363 +6410 4 20.4997 15.2544 31.7027 -1.32541 3.0922 -5.22806 +6411 6 10.6615 22.4234 39.4446 2.77058 -10.3375 -21.7461 +6412 4 10.8237 22.5242 38.4595 -6.54577 -4.89624 27.0726 +6413 4 10.2823 21.5329 39.6036 8.10661 10.4602 -7.72978 +6414 6 25.1119 11.6683 22.7275 17.9584 10.1803 -43.002 +6415 4 25.2932 11.5881 23.6503 -10.3644 -4.73542 30.1579 +6416 4 24.2275 11.4525 22.4127 -3.04384 -6.16919 15.0614 +6417 6 31.7847 10.4664 2.90738 14.6232 4.92747 -25.5509 +6418 4 32.6367 10.8084 3.16838 3.35352 3.27745 17.8769 +6419 4 31.9203 10.4929 1.94425 -15.217 -5.45404 8.94289 +6420 6 52.4827 36.4345 22.1596 -7.80713 -36.8893 3.58418 +6421 4 53.0619 36.0081 21.4904 -7.85296 7.00584 7.09748 +6422 4 52.1113 35.6558 22.6625 11.8438 27.843 -13.8236 +6423 6 46.2218 40.0356 27.0002 3.00948 19.3103 18.0239 +6424 4 46.4695 39.2891 26.4839 7.60887 -23.2108 -12.3358 +6425 4 45.8298 40.6551 26.3816 -4.98516 2.75312 2.41297 +6426 6 24.0859 36.731 39.1057 28.0861 3.14637 -13.7231 +6427 4 23.7868 35.8298 38.9338 -5.18553 -0.74556 5.28182 +6428 4 23.4629 37.185 39.6652 -17.6872 -1.49015 10.8999 +6429 6 22.3474 7.42423 31.8108 -22.1464 -34.764 6.81692 +6430 4 22.3426 8.34479 32.0749 -0.491553 12.3501 5.32307 +6431 4 21.6443 6.94951 32.3421 24.5486 22.6275 -17.4273 +6432 6 14.3601 18.3609 4.10227 -5.91068 -17.6869 34.0105 +6433 4 14.0198 17.4467 4.00899 4.58845 16.3972 -3.13031 +6434 4 14.1964 18.4938 5.07185 10.0688 2.42213 -23.7444 +6435 6 27.3176 38.4584 0.118061 26.6324 1.72941 22.4386 +6436 4 26.8721 39.2229 0.514978 -6.24738 0.955789 -1.68833 +6437 4 28.1825 38.4197 0.615747 -27.5588 -2.17115 -12.0629 +6438 6 18.6641 0.153005 12.2455 -30.1585 11.9093 7.70812 +6439 4 17.6838 0.288413 12.4195 29.795 -10.6896 -3.23208 +6440 4 18.9224 41.3021 12.7767 -6.14336 -8.14908 8.56265 +6441 6 49.4289 24.9791 25.34 -2.93287 6.40986 -7.21031 +6442 4 48.5336 24.6845 25.5066 -4.79022 -10.2209 3.00881 +6443 4 49.2657 25.7332 24.7569 10.0796 0.538989 -0.302405 +6444 6 52.0657 20.2866 15.752 -30.988 -5.77477 12.2451 +6445 4 52.9883 20.4648 15.7877 30.7647 6.19501 2.10932 +6446 4 51.7487 20.318 16.6754 2.59628 0.707672 -8.61894 +6447 6 49.6694 15.6466 38.5033 -2.36871 5.8496 0.21755 +6448 4 49.1634 15.9354 37.7317 2.81773 -6.75889 -8.88584 +6449 4 49.3364 16.2327 39.1899 -1.1635 1.82265 11.9188 +6450 6 15.9209 23.7098 13.4125 14.0576 3.0382 28.6395 +6451 4 16.4576 23.7581 14.2247 -6.14337 -14.5589 -15.9509 +6452 4 15.4928 24.5639 13.4473 -12.8057 7.70559 -12.0572 +6453 6 14.3535 29.1644 14.3158 -5.44214 8.41065 -10.6214 +6454 4 14.1107 29.5404 13.4323 4.3831 -8.60004 22.5031 +6455 4 14.1668 29.874 14.9595 1.02369 -3.68708 -8.8215 +6456 6 30.4209 19.8501 16.8941 13.513 -29.8099 -4.40702 +6457 4 30.8419 19.6061 17.7309 -1.16118 4.00396 0.0836579 +6458 4 29.8867 20.6126 17.0073 -13.0379 22.0094 6.56408 +6459 6 21.3171 21.0315 23.1347 13.77 4.04154 19.3244 +6460 4 22.2214 21.2364 23.4619 -15.8088 -1.32345 -6.31481 +6461 4 20.7299 21.1568 23.8987 5.07857 1.54253 -3.54042 +6462 6 32.3393 0.431439 25.2563 20.1104 -9.0179 2.05206 +6463 4 32.3376 0.357033 24.2893 -5.83171 4.85221 4.50445 +6464 4 31.4939 0.740536 25.5658 -20.5297 5.12544 -3.04931 +6465 6 26.1412 32.4208 27.5133 11.9844 8.82666 12.5058 +6466 4 25.6297 33.2181 27.3271 -3.7928 0.326337 -6.17907 +6467 4 25.9506 31.7475 26.8638 -6.12498 -3.36782 -14.5181 +6468 6 31.6886 23.0183 41.4596 0.904697 7.64904 11.3452 +6469 4 32.5758 22.6752 41.6838 -11.075 0.532718 -2.08438 +6470 4 31.0649 22.7115 0.227606 5.71652 1.16966 -4.3825 +6471 6 54.3662 17.838 10.7289 1.16641 13.6113 28.4031 +6472 4 53.5784 18.2682 10.4091 -15.835 11.3767 1.3744 +6473 4 54.5574 17.2244 10.05 12.0924 -25.2322 -22.7117 +6474 6 15.4007 28.5656 8.62044 -26.1749 5.76845 -41.3303 +6475 4 14.7273 28.9702 8.01425 13.7656 -2.21873 23.1298 +6476 4 15.8479 27.9621 8.001 5.22436 1.48231 12.0756 +6477 6 21.9302 22.318 27.6758 1.68517 -22.7815 -10.3197 +6478 4 22.2029 23.2377 27.6948 5.32233 7.77922 8.4028 +6479 4 21.9507 21.9579 28.5708 1.77406 4.33165 6.10734 +6480 6 2.9439 17.0434 8.14058 1.94164 -24.3442 -12.3304 +6481 4 3.71771 17.0381 7.53295 -10.9103 8.58946 10.7103 +6482 4 2.9095 17.8301 8.67828 12.1388 15.179 1.9509 +6483 6 27.5776 18.2769 3.9771 26.0492 -34.2565 5.18616 +6484 4 26.8914 18.9079 3.85686 -19.1066 25.6869 -8.0303 +6485 4 28.3968 18.6065 3.57961 -12.2542 3.89161 2.52414 +6486 6 24.7648 24.5394 8.45172 0.675902 5.99664 -6.73781 +6487 4 25.0691 23.6382 8.29185 0.995795 -2.08458 0.0885467 +6488 4 24.6379 24.6158 9.40394 1.7631 1.80546 -0.516948 +6489 6 41.9985 30.4652 13.7873 -12.418 22.2399 8.0521 +6490 4 42.948 30.5766 13.6065 -4.54142 -18.1038 -0.632901 +6491 4 41.6543 29.5567 13.7855 17.2179 -0.450275 -1.52495 +6492 6 15.7003 34.688 41.5836 22.5583 -4.71252 2.77114 +6493 4 16.4414 35.3131 41.7067 -7.89455 1.74939 1.29748 +6494 4 14.9091 35.1782 41.7999 -10.5684 8.94915 5.66738 +6495 6 11.14 19.7709 40.5827 8.16812 -24.8495 -13.7269 +6496 4 12.099 19.6958 40.4335 -6.97557 5.6239 6.72769 +6497 4 10.8269 18.8658 40.3418 -4.09458 16.1616 8.77151 +6498 6 47.4994 34.5266 14.3059 -7.29954 -13.2064 -47.3862 +6499 4 46.9486 35.2618 14.0194 -1.26876 14.2822 14.9014 +6500 4 47.5134 34.0178 13.447 14.161 -1.19014 30.6955 +6501 6 12.4113 26.9599 28.4986 7.53387 -39.615 -11.3807 +6502 4 13.2389 26.8759 29.0383 -9.69033 -7.26437 -10.917 +6503 4 12.3547 26.143 27.8911 8.77392 33.3418 27.7102 +6504 6 27.6324 16.2078 39.8226 -15.7166 38.3334 10.2244 +6505 4 27.1738 15.4871 40.2515 -0.529449 -16.0233 0.418904 +6506 4 28.2783 15.8881 39.2072 13.4358 -18.0852 -11.4488 +6507 6 33.41 31.2223 27.2648 1.06056 32.1352 -34.8736 +6508 4 34.1408 31.8147 27.4795 4.37007 -7.45055 8.12396 +6509 4 32.9956 31.7298 26.5244 2.74339 -19.701 12.9858 +6510 6 39.1079 39.5697 31.9277 -2.55925 2.09297 0.92959 +6511 4 38.7672 39.6549 31.0188 2.43701 -1.71218 7.87361 +6512 4 38.6143 40.212 32.4659 5.60044 -5.69156 -1.85126 +6513 6 22.8777 16.5449 19.9566 -5.65986 -8.80894 -1.36967 +6514 4 23.3352 15.8067 20.4264 -14.7096 4.17994 -10.0586 +6515 4 22.0919 16.2116 19.4632 15.4216 -6.99735 9.66589 +6516 6 23.9693 21.8661 10.5894 -36.2244 3.36606 3.40233 +6517 4 22.9782 21.9097 10.6297 20.8239 3.29656 -5.85881 +6518 4 24.1356 21.2379 11.286 10.3432 -8.66819 12.8402 +6519 6 40.1777 25.441 2.79106 -10.2872 18.2283 6.37262 +6520 4 40.1705 25.0132 3.63888 8.49445 -17.5146 10.0011 +6521 4 39.7592 26.2809 3.01477 -1.02299 2.45309 -8.63041 +6522 6 15.0237 19.7749 9.41859 -29.0071 17.4399 5.80075 +6523 4 14.7228 20.7104 9.1599 7.38 -34.1593 9.70733 +6524 4 14.2459 19.2857 9.84339 25.5779 21.3804 -17.4983 +6525 6 7.16152 24.8628 0.123297 -7.02966 -3.56682 11.7049 +6526 4 7.96668 24.8036 41.5398 15.214 -7.46464 -23.6733 +6527 4 7.46323 25.2953 0.914133 -6.27594 4.44234 13.0485 +6528 6 43.3927 10.9201 31.3407 25.4071 10.106 7.84859 +6529 4 43.8098 10.8609 30.45 -7.40798 -0.791197 19.4909 +6530 4 44.1598 10.9733 31.9767 -21.009 -0.343387 -21.8186 +6531 6 13.8353 19.068 27.8558 -6.19586 12.3763 0.85665 +6532 4 12.975 18.7858 28.1864 -1.64107 2.23065 2.52451 +6533 4 13.8413 20.053 27.8412 2.88957 -13.8419 -2.19198 +6534 6 3.4728 19.5924 9.6022 -44.5705 9.69836 1.75794 +6535 4 2.70361 20.0095 10.0844 20.5969 -13.9146 -9.89239 +6536 4 4.25765 19.8234 10.0844 13.5534 0.0599395 5.99295 +6537 6 51.0213 19.4268 7.70955 2.43945 12.0622 -23.2725 +6538 4 50.6325 20.2627 7.28999 21.6228 -31.5555 10.1722 +6539 4 51.8004 19.115 7.16203 -27.7652 18.9123 7.69536 +6540 6 42.2139 2.59999 10.4154 11.3377 -7.01405 -0.847173 +6541 4 43.144 2.57533 10.7556 -19.516 1.89174 -10.2127 +6542 4 42.1979 2.39197 9.45142 9.27815 6.14572 20.7298 +6543 6 30.7794 6.42968 35.1975 -13.4378 -7.3385 -2.08895 +6544 4 29.8146 6.43175 35.3648 9.73054 -4.02703 -1.93701 +6545 4 31.052 5.50707 35.0427 -6.67101 6.52405 0.860042 +6546 6 52.8733 36.9495 18.5906 -4.95733 10.1612 -6.16245 +6547 4 51.9909 36.5548 18.5738 -2.549 -5.51132 1.40056 +6548 4 52.7192 37.8514 18.247 7.64894 -10.0112 4.74408 +6549 6 44.2058 6.2999 1.04709 5.21291 8.10008 11.2107 +6550 4 44.5368 6.97198 1.69742 -2.24215 -10.2401 -12.34 +6551 4 44.9393 6.09517 0.464894 1.54959 1.89788 1.1267 +6552 6 42.1369 38.61 31.1886 17.67 -9.24899 26.4806 +6553 4 41.7623 38.8803 30.3687 -14.3725 6.55505 -24.001 +6554 4 41.498 38.8614 31.8609 -3.32676 4.75778 -0.202389 +6555 6 43.7164 12.7972 9.05712 5.81528 3.72875 -30.711 +6556 4 43.3247 13.6946 8.89573 9.87346 -21.9812 3.16194 +6557 4 44.14 12.4709 8.19462 -12.6006 16.8915 32.7492 +6558 6 13.3844 0.443398 6.51083 -17.4423 24 5.83044 +6559 4 13.1471 1.18968 7.12521 11.9969 -17.0568 -16.1514 +6560 4 13.404 0.824606 5.60344 -0.330864 -2.32474 10.3957 +6561 6 16.1322 13.2809 10.2756 -7.67495 0.483234 -7.74316 +6562 4 16.9315 12.7781 10.4995 -2.28882 -8.98658 -2.43525 +6563 4 15.4389 12.669 9.92885 16.2568 3.72445 6.60733 +6564 6 1.59909 8.47465 4.69565 -12.106 -24.0688 17.9122 +6565 4 1.97809 9.06493 4.05503 13.7499 12.9224 -12.6029 +6566 4 2.17818 8.51684 5.47441 1.43398 4.73372 -5.14276 +6567 6 37.2847 1.71984 10.5234 11.0189 -27.5723 -13.4042 +6568 4 37.2468 2.67416 10.4778 -4.00861 9.27523 10.0347 +6569 4 36.8996 1.35439 11.335 -2.27729 16.2243 3.90618 +6570 6 53.8329 9.87891 17.6846 -38.3798 -30.924 7.14602 +6571 4 54.5301 10.0186 17.0634 18.0368 1.02749 -18.7159 +6572 4 53.3473 9.06138 17.3773 12.8854 20.2391 7.24153 +6573 6 45.4804 30.6107 15.8042 -8.04753 0.598448 7.23065 +6574 4 44.8245 31.2304 16.205 12.7241 -16.0174 -7.51778 +6575 4 45.2045 29.6903 15.9459 -0.384376 11.4708 0.631615 +6576 6 39.9212 16.643 33.8508 -27.7636 -7.17353 -19.4615 +6577 4 39.1766 17.1755 33.458 21.1378 -12.4278 10.7513 +6578 4 39.8244 15.7487 33.4296 5.23768 21.8708 14.061 +6579 6 32.8655 24.7639 27.9361 20.284 59.6053 -7.49862 +6580 4 33.6165 25.1458 28.4374 -8.60268 -19.6727 -0.650124 +6581 4 32.6313 25.5876 27.4183 -1.69816 -34.155 10.7383 +6582 6 7.87466 31.6143 24.1101 1.9117 20.6925 26.3443 +6583 4 7.66972 30.8573 24.7192 5.27436 26.873 -8.7819 +6584 4 7.9908 32.4716 24.6533 -12.57 -44.6195 -20.0842 +6585 6 43.5378 41.3358 15.8218 9.28004 -2.58796 -1.50951 +6586 4 43.1443 0.2957 15.6997 -2.19094 2.48586 -2.7957 +6587 4 44.4004 41.3722 15.3768 -7.99823 -0.449815 2.36698 +6588 6 20.0371 29.5453 33.205 3.08504 -20.5033 -11.6211 +6589 4 20.9096 29.2965 33.5637 -2.90058 10.2459 9.35691 +6590 4 19.6251 30.2513 33.706 8.84517 7.80605 8.87396 +6591 6 43.4117 21.4438 18.6347 -11.1342 -15.0059 14.8538 +6592 4 43.0276 21.2687 19.5098 8.56326 4.46648 -0.801958 +6593 4 42.8532 20.9111 18.0542 1.01153 2.95656 -9.2223 +6594 6 3.44653 19.1197 18.4217 23.6769 1.99723 9.81042 +6595 4 3.20802 20.045 18.3207 -2.32682 2.96104 -2.33529 +6596 4 2.63398 18.6303 18.3598 -12.7596 -8.76931 -2.32568 +6597 6 41.6678 38.1102 16.3244 12.531 -42.2252 -39.0953 +6598 4 41.9368 37.3879 15.641 -15.3799 38.9729 30.6603 +6599 4 42.3331 38.0554 17.0146 -0.0757724 1.18921 2.99625 +6600 6 7.55561 36.3978 10.4983 -3.44092 15.1931 -1.45671 +6601 4 6.72339 36.2337 10.0108 12.3142 -8.52859 4.51616 +6602 4 7.946 35.5335 10.7116 -10.6452 2.04557 -4.50299 +6603 6 36.2515 19.1074 34.8142 -43.7142 -17.0801 -27.3746 +6604 4 35.3817 19.3303 34.3863 23.1726 -6.06315 12.306 +6605 4 36.4633 19.8781 35.3097 10.3 22.3537 14.1292 +6606 6 53.5678 24.9372 12.6442 30.4342 18.5181 -32.2976 +6607 4 53.8348 25.8921 12.6266 -11.9077 -21.6197 10.5864 +6608 4 54.0165 24.5977 11.8224 -16.4724 -4.37861 26.9125 +6609 6 31.6766 10.443 21.0806 4.21881 -9.06253 -2.47208 +6610 4 31.4001 9.76622 21.7243 -7.70504 9.2495 -8.08332 +6611 4 30.9288 10.6617 20.4921 1.78432 -8.02731 8.28605 +6612 6 18.1094 28.7798 17.1891 14.7524 22.0605 -19.6834 +6613 4 19.0758 28.769 16.9872 -20.2742 -2.10771 9.28657 +6614 4 17.7731 29.5847 16.7123 5.43167 -23.0331 15.3038 +6615 6 21.675 18.2354 36.8765 16.12 -15.5286 8.52342 +6616 4 22.5529 17.9072 36.565 -22.4082 10.693 4.11156 +6617 4 21.5572 17.762 37.7329 -6.04816 8.67317 -10.9669 +6618 6 25.0658 19.0188 34.2159 -51.8076 2.97265 19.7815 +6619 4 24.747 18.4039 34.9114 5.38902 10.2451 -10.362 +6620 4 25.8774 18.6629 33.96 52.7001 -22.9877 -15.275 +6621 6 15.5692 13.0234 5.56242 -6.58245 2.44228 -13.4315 +6622 4 15.9945 13.4237 6.33643 -0.981395 -11.5063 2.18089 +6623 4 15.4281 12.0558 5.58603 5.20341 13.6823 8.40676 +6624 6 54.4716 41.6235 14.8012 14.2089 2.8312 2.80672 +6625 4 54.7869 41.5367 15.7234 -10.706 -4.16636 -8.71187 +6626 4 53.6678 41.1066 14.6963 -6.31993 -3.99892 7.53898 +6627 6 1.6781 26.4654 31.3743 5.67012 -21.4195 51.4057 +6628 4 2.55869 26.331 31.7713 -6.41431 -1.4007 -7.54986 +6629 4 1.81482 26.7235 30.4972 11.6805 15.9936 -52.9786 +6630 6 32.3382 37.285 29.6856 -26.7217 17.5069 7.43983 +6631 4 31.5807 37.8924 29.918 20.5429 -15.6126 -5.39856 +6632 4 33.128 37.6701 30.0913 2.74033 -1.11204 0.131524 +6633 6 52.7155 21.0369 22.8986 -26.6856 13.1044 -7.83906 +6634 4 51.927 21.5218 22.5308 17.9584 -10.8856 16.9396 +6635 4 53.1096 20.6236 22.131 10.0871 -9.76004 -3.40095 +6636 6 32.7546 28.5936 40.5151 -16.005 5.57574 20.6704 +6637 4 31.9696 29.0914 40.2712 1.08408 5.35728 -15.103 +6638 4 32.4826 28.2925 41.3957 13.2257 -7.23298 -6.66392 +6639 6 23.6064 32.0719 16.3529 6.2601 0.887785 0.577407 +6640 4 24.375 31.9361 16.9584 -22.6405 4.1158 -3.2487 +6641 4 22.7879 32.3052 16.8361 12.3926 -5.56708 -0.502672 +6642 6 37.5201 9.16809 29.9792 -2.73778 -7.47015 7.66604 +6643 4 36.7801 8.78215 30.4957 3.311 11.363 -11.2805 +6644 4 37.2059 9.98527 29.541 -5.1069 -9.85197 8.55889 +6645 6 2.27705 24.391 14.5477 -18.8311 -23.8216 -15.5117 +6646 4 1.75426 24.0938 15.3142 10.0576 11.8704 2.19803 +6647 4 1.95568 23.7778 13.8474 11.5886 17.7779 11.9828 +6648 6 27.3753 28.7961 24.7726 7.21008 -25.2057 -20.8265 +6649 4 27.1644 28.4274 25.6317 -2.92196 -0.0765173 10.3399 +6650 4 27.4291 28.0161 24.1505 1.02404 24.316 14.9 +6651 6 16.7879 2.56531 14.3086 11.9129 14.2285 -1.69346 +6652 4 17.7185 2.38196 14.3175 13.0278 5.32386 8.84309 +6653 4 16.4775 1.81817 13.8231 -22.7045 -15.6449 -12.1127 +6654 6 21.8022 39.8027 36.8001 40.4582 11.674 1.33338 +6655 4 22.755 39.5599 36.9347 -17 12.4394 -0.288792 +6656 4 21.461 38.9709 36.5396 -21.7153 -28.8447 -11.0269 +6657 6 14.0716 6.47232 41.542 21.0202 -14.2424 -6.97231 +6658 4 14.9696 6.10406 41.5939 -1.81915 -4.72532 -7.76656 +6659 4 14.0403 6.99701 0.421866 -13.8031 9.98176 13.4178 +6660 6 14.5555 16.5106 9.31543 20.3876 4.44524 4.12907 +6661 4 15.4025 16.5964 9.78828 0.864554 -6.42184 -12.9633 +6662 4 13.9847 17.046 9.86181 -12.8914 3.93145 3.80898 +6663 6 8.66171 23.4817 30.5575 -0.244333 -0.896371 32.8135 +6664 4 9.54353 23.6001 30.2398 18.7576 4.73722 -27.2602 +6665 4 8.85707 23.3999 31.5064 -16.6456 -3.41855 -0.290363 +6666 6 37.6497 2.07069 20.0046 29.2824 -26.1096 14.9164 +6667 4 37.0584 2.2163 19.2662 -13.6051 13.4744 -1.64318 +6668 4 37.4656 2.68422 20.7276 -9.488 6.31449 -9.7769 +6669 6 42.7264 7.54802 8.0174 22.2735 -23.3375 63.966 +6670 4 43.1898 7.96838 7.30926 14.9789 10.8108 -11.9713 +6671 4 43.3711 7.43923 8.8454 -34.4126 10.1207 -51.4479 +6672 6 38.5672 29.6578 6.85692 25.3422 5.29964 1.58487 +6673 4 38.5311 29.2984 7.75245 -9.71234 0.328663 -2.10015 +6674 4 37.7248 29.5682 6.41889 -15.2832 -4.18317 0.54199 +6675 6 42.5348 15.7114 39.7967 1.15785 13.3588 -25.5786 +6676 4 42.7129 16.6429 39.5831 1.88136 -1.51067 11.9166 +6677 4 42.2359 15.3735 38.9271 3.70013 -4.77916 17.2749 +6678 6 19.8546 7.43685 22.0566 -22.5975 2.81071 25.7956 +6679 4 19.2803 8.13273 21.6746 8.521 -7.13733 1.21439 +6680 4 19.4015 7.21173 22.9242 12.7412 8.86068 -31.9054 +6681 6 27.421 3.23371 12.5304 27.0524 21.0752 -24.489 +6682 4 28.3367 3.35644 12.1327 -27.9555 -7.8832 14.1518 +6683 4 27.3543 2.31638 12.8154 4.42645 -1.52034 -0.990676 +6684 6 34.4011 6.50186 34.3664 -16.3424 -2.90191 9.94761 +6685 4 33.6712 7.15225 34.4215 6.78416 -7.62851 1.00734 +6686 4 34.1394 5.7575 34.9538 2.66911 12.7001 -5.69623 +6687 6 9.88701 27.9536 39.7574 38.1218 -1.21446 9.36845 +6688 4 10.8313 27.9815 40.1009 -35.4969 -5.93471 -11.3457 +6689 4 9.7403 28.8357 39.397 -3.9481 4.17466 -3.11552 +6690 6 50.5681 22.1235 6.40489 -3.33101 1.51672 6.50125 +6691 4 51.5163 22.3536 6.46403 -14.0562 3.33212 10.0382 +6692 4 50.0608 22.5915 7.10741 15.6039 -2.37345 -9.267 +6693 6 47.1098 11.477 30.0359 32.4056 2.61276 18.961 +6694 4 47.3696 10.9259 30.8115 -10.3246 7.95021 -16.9085 +6695 4 46.3045 11.1726 29.6407 -20.48 -14.5539 -1.24473 +6696 6 25.9367 28.4654 9.80931 -8.38409 -27.2904 31.5361 +6697 4 26.8395 28.2564 10.1264 -14.1867 1.81997 -4.27567 +6698 4 25.3175 27.9176 10.3882 19.4096 21.4407 -17.1039 +6699 6 35.4417 36.6052 19.4431 3.65383 9.51374 12.5698 +6700 4 35.4442 36.5892 20.4356 4.35023 4.13201 -20.4161 +6701 4 36.0823 37.2978 19.1702 -7.18083 -5.57131 7.61291 +6702 6 39.0947 17.861 12.3005 -1.37104 18.7141 6.38745 +6703 4 39.0516 18.8013 12.5757 6.4741 -5.57949 -8.41576 +6704 4 38.3925 17.481 12.8252 -9.64523 -10.3587 5.73293 +6705 6 2.67895 27.1328 2.39169 -0.469231 -1.96621 -7.87892 +6706 4 2.01695 27.5866 1.84113 6.06579 -3.44887 4.00529 +6707 4 2.54603 27.3828 3.31988 1.36543 -1.57126 -4.01383 +6708 6 12.3125 32.2183 21.5204 7.73608 31.3279 -34.5621 +6709 4 12.8754 32.1648 22.302 -15.5368 -9.13091 6.69049 +6710 4 11.4514 31.7997 21.5885 -0.151568 -8.94455 23.3893 +6711 6 32.8824 32.3641 8.46179 -18.8611 4.30442 3.1153 +6712 4 33.4241 32.9657 8.96292 17.2175 7.79223 5.74753 +6713 4 32.0088 32.7748 8.50666 0.635289 -6.40729 -7.5616 +6714 6 12.649 6.44414 31.9754 -2.83404 4.50046 10.0363 +6715 4 13.204 6.32185 31.2101 8.19857 -2.9014 -11.0209 +6716 4 11.7563 6.235 31.704 -2.09981 -3.08597 -3.85403 +6717 6 41.3663 27.7408 14.044 -7.1512 -14.0341 -18.9391 +6718 4 41.8178 27.3798 13.2339 -12.2472 13.3456 19.5442 +6719 4 40.4043 27.5413 13.9741 19.5004 0.843126 1.31278 +6720 6 6.61204 16.505 25.4358 4.38086 10.1107 -4.22872 +6721 4 7.40634 15.95 25.3995 -3.52048 -0.326181 -5.74655 +6722 4 5.93615 16.0015 24.9584 5.4209 -2.01242 3.85811 +6723 6 21.7595 39.2992 13.3504 -47.5104 6.20728 42.9111 +6724 4 22.3466 39.2605 12.6295 26.4998 6.28224 -34.1528 +6725 4 21.7095 40.2078 13.7281 10.6984 -16.5323 -14.9329 +6726 6 34.8487 6.01484 6.95222 -29.6963 0.326386 -14.1862 +6727 4 33.862 5.88861 6.88689 25.1099 2.0969 11.0318 +6728 4 35.0754 6.24807 6.0365 6.49139 -1.48305 5.74594 +6729 6 33.0274 30.4243 33.1708 -20.2868 -13.6057 -33.0226 +6730 4 32.107 30.5622 32.8069 24.6222 -1.48625 15.7647 +6731 4 33.1252 31.0225 33.8918 -2.19017 18.1524 16.6028 +6732 6 15.459 32.4153 12.1907 25.026 -14.7999 12.6103 +6733 4 16.3707 32.0454 12.2858 -22.5133 7.43237 -2.39957 +6734 4 15.4871 32.8857 11.3664 4.63911 10.1509 -16.175 +6735 6 12.6896 26.6018 21.3639 -15.0944 -25.6853 -2.70918 +6736 4 11.948 26.0906 21.6799 0.937138 -29.673 -19.3981 +6737 4 12.542 27.2759 21.9777 19.0907 58.813 21.5342 +6738 6 47.0229 36.3064 29.9951 -7.32095 -4.41829 24.4392 +6739 4 47.4263 37.0889 30.4354 -10.9743 -13.05 -1.23566 +6740 4 46.4286 35.8162 30.6445 23.161 23.2616 -16.2608 +6741 6 0.29284 12.714 23.4069 -35.5625 7.7859 6.41586 +6742 4 0.591011 11.8915 23 -3.04289 0.952694 -0.179009 +6743 4 54.2726 12.6526 23.4069 36.7156 0.482893 -0.227565 +6744 6 54.1717 18.9252 21.5683 -50.0663 20.0699 0.290361 +6745 4 -0.00468748 18.6783 21.9698 30.2345 -16.5238 -1.58257 +6746 4 54.0846 18.73 20.626 15.626 -5.42297 0.74208 +6747 6 25.7258 24.2992 23.7444 19.803 -45.4072 -0.235584 +6748 4 25.1532 23.5493 23.4006 14.0979 28.9064 13.4272 +6749 4 26.557 23.8171 24.0636 -29.432 23.3848 -10.2309 +6750 6 11.8983 29.0288 26.8736 6.09277 -0.515715 3.71925 +6751 4 12.595 29.6797 27.0784 -3.35093 -5.68029 1.25498 +6752 4 11.9864 28.3255 27.5444 1.01315 10.8055 -7.75858 +6753 6 47.9911 35.8567 10.6981 8.08413 -4.02984 -21.6227 +6754 4 48.7745 35.7734 10.1229 -13.6418 -1.85084 -2.1863 +6755 4 48.3792 36.2903 11.4463 -1.30569 7.34959 21.4512 +6756 6 47.672 29.8438 36.9511 38.562 -32.0587 -16.7646 +6757 4 48.1514 29.311 36.2244 -26.8687 25.3781 26.6073 +6758 4 46.9232 30.3209 36.5927 -0.690739 -0.634879 -8.58348 +6759 6 7.33835 12.3416 10.615 -8.89583 -3.33234 -10.1121 +6760 4 7.22469 12.7824 9.73793 -1.24183 -8.23722 19.221 +6761 4 6.50851 12.5236 11.1156 17.4449 -0.896679 -14.5349 +6762 6 52.929 15.961 4.90278 -10.2898 -1.28264 -8.50781 +6763 4 53.0348 16.1145 3.95774 -1.18717 -0.815743 4.35872 +6764 4 53.806 16.0238 5.26597 15.814 -0.370642 9.21047 +6765 6 10.6777 16.9586 34.6035 -55.1347 -38.7426 5.67968 +6766 4 10.8984 16.7766 35.5088 23.7364 14.024 15.8473 +6767 4 9.8802 16.3472 34.5582 30.0556 27.9196 -18.3163 +6768 6 25.1377 31.056 36.0048 1.42921 -10.848 -28.6765 +6769 4 25.7744 31.7772 36.0714 -0.417948 1.95283 3.18329 +6770 4 25.3475 30.6244 35.1463 -8.66047 8.51414 18.9355 +6771 6 34.0941 21.8921 41.4705 -2.59948 8.49748 21.8065 +6772 4 33.8376 21.0023 41.2487 -0.891159 -17.6747 -3.00217 +6773 4 34.5263 22.2081 40.6953 10.3371 11.5397 -24.1167 +6774 6 15.7674 30.0637 1.25444 19.4532 4.17941 -23.0135 +6775 4 15.204 30.4318 1.91689 -16.4157 4.77211 21.8875 +6776 4 16.1981 30.8773 0.915598 -5.77798 -19.2538 1.08217 +6777 6 29.5177 27.8662 16.6069 -21.9867 -20.8772 26.8051 +6778 4 29.4575 26.8938 16.8925 2.72258 42.9501 -5.19299 +6779 4 28.8337 28.3532 17.1557 16.905 -14.8206 -13.8895 +6780 6 39.6418 9.77683 0.55649 6.97543 15.8838 23.3716 +6781 4 40.1108 10.6055 0.868863 -11.4024 -23.0197 -7.66085 +6782 4 39.4946 9.23542 1.36828 3.21978 8.9832 -14.2415 +6783 6 1.52158 31.8692 16.4183 -13.8984 7.04184 27.8471 +6784 4 2.05742 32.2974 15.7673 16.5414 8.9668 -16.2997 +6785 4 1.54493 30.9444 16.2035 3.31157 -20.7597 -8.56027 +6786 6 8.73651 39.8559 25.0424 -4.76165 -15.5453 0.0774869 +6787 4 8.05377 39.648 25.6948 0.177415 -5.7342 -2.33302 +6788 4 8.86744 40.7877 25.1714 9.39418 20.2019 -3.50565 +6789 6 42.3206 10.2864 9.76098 2.95973 19.1246 -1.63703 +6790 4 42.201 10.133 10.7061 4.21692 -0.996774 -0.328573 +6791 4 42.7677 11.1578 9.6855 -5.09192 -13.1904 -0.0451331 +6792 6 13.2407 7.61713 1.96996 -7.39862 -1.41628 8.88927 +6793 4 13.9913 7.91748 2.51852 -7.45732 -2.50241 0.703823 +6794 4 12.5579 7.21318 2.54911 15.3337 9.06064 -6.21655 +6795 6 18.7418 40.0591 14.2229 14.6643 6.60726 6.61579 +6796 4 19.3344 39.8885 14.9901 -13.3575 3.17545 -12.3588 +6797 4 17.9636 39.4956 14.2872 3.6042 -5.87931 7.54738 +6798 6 20.1073 14.0529 38.5598 27.8117 -61.2518 1.76132 +6799 4 20.1641 13.6472 37.6602 -4.05869 13.902 17.7453 +6800 4 19.784 14.907 38.4293 -21.3136 56.4597 -12.4562 +6801 6 22.6529 28.8869 34.0687 6.58134 -12.6264 20.4136 +6802 4 23.051 28.2341 33.486 -0.980474 2.102 -8.59088 +6803 4 22.967 28.5961 34.9503 -6.50134 7.38476 -6.63172 +6804 6 22.6736 4.71248 5.24178 -0.00794307 -2.96021 -16.86 +6805 4 22.1728 3.90748 5.48978 2.26378 16.1145 9.27739 +6806 4 22.7088 5.35566 5.95806 -4.05577 -5.29394 11.9552 +6807 6 23.6374 34.0001 38.3917 50.061 26.1352 -20.3518 +6808 4 22.8137 33.6238 38.6177 -41.7704 -11.5062 -0.965889 +6809 4 23.6153 34.3835 37.4812 -9.56218 -11.3792 16.4738 +6810 6 48.3816 21.3644 17.2759 -0.964958 21.4078 15.1884 +6811 4 48.1603 22.346 17.2347 5.31328 -30.3781 -7.15015 +6812 4 48.2799 20.9337 16.4123 -2.86285 15.3202 1.32987 +6813 6 11.5786 11.0066 8.63803 -22.8025 30.9503 41.2381 +6814 4 11.6342 10.2487 9.24135 6.24209 -4.12245 -6.65597 +6815 4 11.0653 11.6976 9.17674 20.0011 -23.9124 -25.5895 +6816 6 40.098 28.1667 33.502 25.4322 5.13826 0.328547 +6817 4 41.0532 28.3457 33.4282 -8.43417 -7.39989 8.78785 +6818 4 39.8078 28.5143 32.6608 -12.8477 1.2165 -2.93222 +6819 6 47.3852 25.6796 5.28879 12.5804 32.9376 -10.0311 +6820 4 46.4546 25.5561 5.13624 -16.8804 -10.2001 -0.268496 +6821 4 47.5232 26.6241 5.03253 2.87445 -14.5067 3.75712 +6822 6 21.6604 35.221 23.9985 9.0652 15.9564 -12.6156 +6823 4 21.5339 34.4977 24.6161 5.50034 -7.33202 6.93593 +6824 4 22.5891 35.5406 24.0132 -10.9025 -9.97729 6.37443 +6825 6 8.25067 41.5023 8.40693 4.57396 0.593767 -7.67714 +6826 4 8.14583 40.8128 7.73311 1.23406 2.32353 -0.157563 +6827 4 7.86929 41.1416 9.20784 -2.18245 3.41182 6.12515 +6828 6 16.4756 31.0916 22.2208 -15.8048 -5.76047 -3.57767 +6829 4 16.9823 30.8797 21.4186 0.224111 -1.11381 3.57708 +6830 4 17.0871 31.1495 22.9566 10.3822 -1.94934 1.40451 +6831 6 54.7052 0.441622 28.3216 30.4392 7.42547 7.16367 +6832 4 0.670225 0.280878 28.2941 -2.60978 -25.0778 -11.1355 +6833 4 54.7831 1.35385 28.5964 -22.0828 12.0381 3.63841 +6834 6 48.4365 15.3814 4.18175 16.1137 -59.8395 -8.29881 +6835 4 49.2486 15.0627 4.66696 -19.7577 20.5705 -9.22457 +6836 4 48.202 14.5739 3.61717 1.65501 39.0327 16.4105 +6837 6 34.3447 6.98096 40.4233 28.1894 -26.1309 -0.966046 +6838 4 33.5941 7.1072 39.8443 -1.28272 -2.58724 -7.46065 +6839 4 35.0352 6.39393 39.9745 -30.768 20.5054 8.50532 +6840 6 41.3452 3.36617 16.9999 -11.8967 -16.9054 2.63506 +6841 4 41.0249 2.72492 17.6694 2.1854 6.18106 -7.89089 +6842 4 41.9449 3.92974 17.49 7.08552 9.22633 4.28017 +6843 6 48.4488 20.6937 14.5344 36.1561 -40.2628 27.2518 +6844 4 47.9962 21.3635 14.0898 -25.7182 45.1623 -29.349 +6845 4 49.3977 20.8911 14.4834 -7.22111 0.680744 -3.09477 +6846 6 52.5006 28.1422 37.1181 -0.438891 10.9489 1.55023 +6847 4 53.461 28.2559 37.0441 -2.53591 -5.73983 -7.32344 +6848 4 52.1579 27.9957 36.2188 6.05301 2.29627 6.02383 +6849 6 53.8778 18.5596 18.7916 -16.4261 -54.6782 2.06415 +6850 4 54.6924 18.1462 18.492 5.89253 -2.608 -0.931268 +6851 4 54.0684 19.4623 18.7843 11.279 55.5152 0.463912 +6852 6 40.9954 39.1455 28.7887 -28.6383 -4.85259 53.4888 +6853 4 41.3933 39.2419 27.9663 30.849 7.00679 -57.5311 +6854 4 40.0484 39.2316 28.6375 -4.32997 -1.25138 -0.266272 +6855 6 38.2708 8.75593 24.2289 27.2886 -4.9888 -5.43324 +6856 4 39.2171 8.59021 23.9715 -26.3742 3.09491 7.04217 +6857 4 38.3303 9.34105 24.9905 -3.83131 2.71498 5.53525 +6858 6 2.99948 29.1469 9.63392 26.6909 -34.1608 2.5373 +6859 4 2.51216 28.7995 8.89273 -4.75194 -2.8028 -9.24178 +6860 4 2.58111 29.9575 9.82954 -15.8869 33.6035 13.3424 +6861 6 27.5773 29.2771 18.3181 4.27818 -11.5166 33.1226 +6862 4 26.7531 29.1546 17.8331 -9.3021 -0.872639 -4.78576 +6863 4 27.3558 28.9731 19.2647 9.0806 12.9475 -44.783 +6864 6 11.8527 21.1658 10.1208 3.44892 -32.1211 19.512 +6865 4 12.1978 22.0146 9.89711 8.39983 22.4635 -8.03232 +6866 4 12.4593 20.8304 10.8135 -12.0936 9.66798 -13.0295 +6867 6 16.8988 32.3014 0.299949 1.29982 1.68058 -0.586211 +6868 4 17.7043 32.7282 0.600499 13.9817 -1.747 3.00212 +6869 4 16.3216 33.0562 0.17902 -12.1561 7.80428 -5.7129 +6870 6 1.309 17.4831 22.5447 23.3848 -11.3219 -15.6007 +6871 4 1.13597 16.5744 22.1718 3.15619 19.2398 8.80125 +6872 4 2.27868 17.6899 22.4311 -25.7511 -7.40397 3.71946 +6873 6 41.5587 6.87311 29.3039 4.08196 29.5448 1.53382 +6874 4 41.6919 5.95311 29.5356 2.80206 -5.98386 3.69024 +6875 4 41.9106 7.40602 30.0483 -3.99043 -10.4039 -5.51054 +6876 6 10.5167 10.7886 13.8618 17.7458 -17.1897 13.2051 +6877 4 10.6632 11.2096 13.003 1.79898 0.261401 -4.84225 +6878 4 11.2159 10.1 14.0373 -16.1376 17.4326 -7.31573 +6879 6 39.8332 15.4952 40.8309 13.3581 4.75609 3.89566 +6880 4 39.9392 16.0809 40.0548 0.3292 -3.56753 7.15077 +6881 4 40.6564 15.5643 41.3732 -15.0531 5.58747 -11.8726 +6882 6 26.5094 19.6057 40.5003 9.17758 -2.41024 9.24949 +6883 4 27.4312 19.885 40.5187 -1.32295 2.31326 -8.74715 +6884 4 26.4504 19.08 41.3172 -10.7617 -0.025449 -2.36491 +6885 6 54.0331 8.19348 13.7645 20.1265 23.4755 -3.20859 +6886 4 54.5379 7.42769 14.0195 10.1236 -9.46733 3.3174 +6887 4 53.1635 7.89609 13.5919 -33.2862 -9.18344 -4.84573 +6888 6 15.685 25.3343 10.6639 3.77823 -5.01457 0.699023 +6889 4 15.2925 25.3549 9.7704 -6.94194 -0.507815 8.78718 +6890 4 14.9859 25.2981 11.3464 3.26271 -0.250944 -15.837 +6891 6 18.6044 3.42728 21.9359 54.0117 -4.17358 13.1129 +6892 4 19.6007 3.50499 22.1915 -55.8621 -1.2706 -18.0159 +6893 4 18.5414 3.70523 21.0018 -0.6471 0.781857 10.4283 +6894 6 50.8906 20.6382 18.514 19.322 19.8933 14.7131 +6895 4 50.0771 21.0514 18.1693 2.40506 3.30677 2.13188 +6896 4 51.4314 21.2881 19.0676 -26.3068 -18.4046 -20.3942 +6897 6 53.3692 20.9044 31.2861 -2.87581 -0.0590227 -4.61483 +6898 4 53.3163 20.8663 32.2507 -1.10677 -1.05899 -2.14121 +6899 4 52.4655 20.8115 30.924 8.48272 0.484508 7.85381 +6900 6 52.8175 27.637 28.9992 -34.1073 -16.3293 -5.23745 +6901 4 52.1753 27.4604 29.7292 18.9476 13.4611 -8.14668 +6902 4 53.5412 28.184 29.256 17.7352 16.912 19.7012 +6903 6 33.3098 15.691 11.3293 10.3241 5.44869 29.2776 +6904 4 33.5439 15.9761 12.2647 -8.49351 -12.0766 -30.078 +6905 4 32.4682 16.1118 11.1139 -1.38634 1.49203 3.14806 +6906 6 20.3823 26.792 27.4754 10.6616 14.7237 17.2289 +6907 4 19.6846 27.4135 27.2507 -4.69437 -0.849554 -6.03625 +6908 4 20.895 27.2908 28.1563 -10.3656 -18.3754 -15.2612 +6909 6 8.54404 2.05454 14.1651 1.1449 13.7122 2.29602 +6910 4 8.12946 1.19872 14.2191 -6.02545 -13.9865 0.607463 +6911 4 8.06484 2.58201 14.8308 4.74922 -3.38849 -5.44478 +6912 6 40.1105 7.56396 40.6794 -0.469697 6.72942 -1.63666 +6913 4 39.7195 8.28533 41.2425 20.0171 -18.0739 -7.27063 +6914 4 40.8018 7.03949 41.1472 -13.6242 13.5344 3.71207 +6915 6 6.897 6.83213 10.7811 7.71606 15.0782 -3.77655 +6916 4 7.19774 7.75246 10.6132 -6.74961 -17.2243 4.00207 +6917 4 7.00156 6.6927 11.7358 -2.06706 0.697676 -4.80225 +6918 6 31.2469 6.57665 20.133 15.2512 -44.8317 5.05575 +6919 4 30.6435 5.99888 20.634 -3.65198 3.16249 1.16613 +6920 4 30.7682 7.35458 19.9689 -22.0921 35.6742 -6.0398 +6921 6 54.5384 21.0446 27.3066 23.2273 -48.3206 40.5729 +6922 4 0.0992734 20.2122 27.4067 -21.2046 24.987 7.15799 +6923 4 54.6588 21.2398 26.4073 -2.82622 20.9035 -45.5707 +6924 6 4.74298 23.1434 16.2203 -30.2995 19.4891 -12.6787 +6925 4 4.36556 24.0555 16.215 7.46998 -18.526 0.357752 +6926 4 5.49124 23.2367 16.7883 23.1348 -5.45784 14.6166 +6927 6 25.5466 11.0338 14.8277 10.3359 0.700294 4.3384 +6928 4 26.1246 10.3443 15.2243 -8.70528 11.4294 -11.7317 +6929 4 25.9183 11.8873 15.0941 -0.865353 -5.34287 -3.41216 +6930 6 41.1962 41.784 29.9422 -30.017 -5.50367 -10.8152 +6931 4 40.9141 40.905 29.5845 10.5201 22.1914 8.67773 +6932 4 40.3904 0.453034 29.9085 19.4524 -11.6054 2.3136 +6933 6 52.2783 15.2862 41.6211 7.07203 -4.19206 -10.8941 +6934 4 51.9431 15.9476 0.307056 -1.67854 11.1856 8.97788 +6935 4 51.5699 14.6487 41.5543 -8.05659 -11.9472 -4.98288 +6936 6 37.758 21.7866 37.8526 10.4754 12.291 4.40187 +6937 4 37.8833 20.8525 37.7239 2.64231 -18.5298 -3.43162 +6938 4 38.1062 21.9123 38.7409 -0.189838 4.59809 2.45253 +6939 6 23.846 9.72877 27.5599 -20.0483 -53.0743 -18.3837 +6940 4 23.7508 8.9538 26.878 9.78252 41.145 35.6193 +6941 4 23.2758 9.50619 28.3397 9.82275 7.24107 -18.911 +6942 6 43.0179 28.0371 32.8168 -8.27592 12.0689 -0.875134 +6943 4 42.8326 27.1827 33.2413 14.9994 1.75302 -2.99965 +6944 4 43.9358 28.1723 32.5349 -8.32605 -13.2452 6.20231 +6945 6 34.1493 21.223 11.895 -6.4617 -26.4803 6.62596 +6946 4 33.7114 20.3967 12.2433 5.74917 23.5867 -12.2191 +6947 4 33.6625 21.5015 11.0997 -1.34318 -2.64619 5.02085 +6948 6 10.5048 31.8203 10.0934 3.12763 27.8567 -5.97475 +6949 4 10.8893 32.6663 10.3856 -2.25958 -16.5293 2.97323 +6950 4 10.042 32.0955 9.27903 1.62317 -10.8132 6.61598 +6951 6 35.8582 37.1311 22.1219 17.442 6.8165 -15.3109 +6952 4 36.7754 37.4644 22.0121 -13.2022 -8.29883 -6.66499 +6953 4 35.6795 37.2674 23.0383 -11.5038 0.0185045 25.2366 +6954 6 27.2889 4.59659 27.4585 -59.4895 -12.2555 32.2126 +6955 4 27.8503 4.63259 28.2407 7.94553 1.46958 -1.61102 +6956 4 26.3513 4.38137 27.8533 49.6255 8.2673 -26.6042 +6957 6 39.0071 22.2889 10.6559 -18.7539 6.55471 8.53947 +6958 4 39.6145 22.0219 9.97399 11.0637 -4.63202 -10.5583 +6959 4 38.132 22.2267 10.2407 1.98377 -6.13574 3.6668 +6960 6 30.7475 39.195 10.9378 13.4076 -25.4475 -2.13886 +6961 4 31.7135 39.1987 10.9202 1.84768 25.2682 1.10777 +6962 4 30.6542 38.2342 10.8274 -15.9936 9.0572 -1.5893 +6963 6 44.6038 26.9469 2.19596 -3.02312 -2.7981 0.496435 +6964 4 44.789 26.0668 2.58199 4.34993 15.1048 -14.5643 +6965 4 45.3477 27.2287 1.63769 1.54159 -5.20589 8.29494 +6966 6 23.7761 14.5574 26.4892 -1.60295 28.5342 -20.4107 +6967 4 23.6176 15.1119 25.659 4.49284 -25.3407 28.839 +6968 4 23.2395 13.7622 26.4238 -2.18231 -2.53609 -2.40557 +6969 6 38.3444 13.3746 39.6516 36.4054 -1.80378 3.51049 +6970 4 39.1202 13.8805 40.0461 -33.1028 -11.4882 -12.1373 +6971 4 37.5326 13.855 39.8351 -2.35218 5.60767 6.28087 +6972 6 17.8972 17.2344 29.4073 9.50877 -9.96512 10.1834 +6973 4 17.6974 16.8197 28.5593 -3.90288 0.722299 -3.3346 +6974 4 17.259 17.9348 29.5179 -13.7448 8.39178 0.729907 +6975 6 17.4263 29.84 9.91085 4.63967 13.4244 18.4952 +6976 4 16.5241 29.7155 9.63978 -6.68442 -7.79832 -10.641 +6977 4 18.0121 29.6473 9.18714 6.17675 -5.88453 -9.84082 +6978 6 35.6257 6.05657 19.614 -2.53427 -7.67526 1.74575 +6979 4 35.1442 5.56448 18.9178 7.07991 15.7277 0.668344 +6980 4 35.8526 6.94177 19.2847 -2.44106 -6.98166 -5.33042 +6981 6 18.6731 22.2952 17.5195 -8.35574 4.99894 -0.254983 +6982 4 17.7298 22.4259 17.6349 -7.1371 0.699885 10.6378 +6983 4 18.7532 22.3981 16.578 9.97204 2.32932 -16.3296 +6984 6 20.0126 3.82895 32.2846 -5.38506 7.6032 10.998 +6985 4 19.7316 4.05659 31.3951 3.95105 0.959407 -6.40709 +6986 4 20.9087 3.45699 32.2166 -3.62371 1.18893 -2.87546 +6987 6 5.48106 6.97474 8.11911 -13.3431 -28.5569 -4.23146 +6988 4 5.76723 7.87539 8.05126 9.5873 19.9723 5.64469 +6989 4 5.84003 6.56862 8.91875 4.365 4.20298 7.41399 +6990 6 44.2055 20.527 25.594 -36.5422 -32.7496 -22.1294 +6991 4 44.4952 21.1964 26.2048 27.2712 12.1663 0.509182 +6992 4 44.8136 20.1687 24.9192 13.264 16.717 13.5958 +6993 6 43.9676 36.9898 17.8707 9.43563 13.9581 11.3899 +6994 4 44.6425 37.4866 17.3506 -13.9886 -14.2814 1.04264 +6995 4 43.5166 36.316 17.3518 1.57776 -4.71986 -9.07493 +6996 6 34.624 10.1249 16.2553 -3.80507 -0.870494 -23.8528 +6997 4 34.4029 10.0232 15.2766 7.60873 7.05542 33.3523 +6998 4 34.6485 11.0843 16.4397 0.136369 -4.79707 -6.11079 +6999 6 23.6588 3.43472 1.31587 2.0947 2.20184 -10.1691 +7000 4 23.5283 2.45383 1.23665 3.68597 29.2686 -10.0862 +7001 4 23.7829 3.95594 0.465507 -5.48879 -27.0668 21.3429 +7002 6 33.408 38.9514 5.0951 12.9752 29.4037 8.61745 +7003 4 33.0296 38.079 4.95882 -18.4714 -2.71742 3.9597 +7004 4 32.7559 39.6696 5.33685 4.56028 -29.4715 -9.24259 +7005 6 22.5612 32.5054 35.7914 -7.59797 17.3543 -6.08959 +7006 4 23.434 32.1498 35.9581 8.59623 -0.183209 1.98348 +7007 4 22.6598 33.4814 35.6698 2.01652 -18.126 2.22848 +7008 6 32.4197 37.2669 13.8205 20.7322 22.1346 -9.91782 +7009 4 31.6112 36.8955 13.5272 -29.3682 -10.7083 -8.61391 +7010 4 32.7793 36.5983 14.3861 8.71878 -17.2052 10.8721 +7011 6 52.6061 12.7509 39.5955 -8.08982 -5.36768 -0.728302 +7012 4 53.2357 13.3696 39.2333 6.80499 9.05338 -6.44134 +7013 4 53.0752 12.2813 40.2869 4.34006 -2.9945 3.85342 +7014 6 28.8406 14.5639 1.22393 13.2702 13.2594 -7.07732 +7015 4 28.2547 13.832 1.29641 -8.98786 -23.9917 -3.18497 +7016 4 28.3081 15.2705 1.57856 0.691728 8.20301 3.76967 +7017 6 1.46371 32.4171 23.3808 -12.1734 -25.5645 13.9938 +7018 4 1.52421 31.5049 23.0145 7.51613 19.861 -1.66683 +7019 4 1.90409 33.05 22.8306 10.4998 5.06095 -20.3958 +7020 6 54.3326 23.3294 28.9734 2.61182 15.3833 -1.51239 +7021 4 54.2696 22.9227 29.8387 -0.130455 -4.55084 5.05008 +7022 4 54.4476 22.6226 28.3359 -0.0534198 -9.82677 -0.516761 +7023 6 14.3165 12.143 35.6759 -19.2415 -8.81627 -0.503167 +7024 4 14.3877 12.7977 36.3527 0.233596 18.6669 11.2481 +7025 4 15.2077 11.8775 35.5438 25.0768 -7.98239 -7.51161 +7026 6 18.9926 6.51479 41.2701 -28.9824 -29.6237 1.81046 +7027 4 18.266 5.84223 41.3522 13.7729 17.3268 -5.20094 +7028 4 19.3309 6.57432 0.258232 8.64619 7.1183 4.95474 +7029 6 5.3156 17.8978 20.3375 -21.1545 16.5991 3.60383 +7030 4 4.72623 18.3448 19.6879 4.29754 -5.05212 8.41069 +7031 4 4.82948 17.9368 21.1935 9.1049 1.98802 -15.8618 +7032 6 24.7216 34.9676 30.1666 -3.07326 -14.2394 -14.8574 +7033 4 24.8542 35.9126 30.1802 4.14387 12.0412 4.3338 +7034 4 24.7023 34.7085 29.2239 -0.0690866 8.67132 12.606 +7035 6 31.8759 4.61762 18.1838 16.2734 -6.94643 -1.61547 +7036 4 31.7767 5.32612 18.8146 -0.693712 9.66586 8.6442 +7037 4 30.9961 4.53608 17.8264 -12.7431 -2.99311 -6.3499 +7038 6 8.70679 17.4876 5.93376 -7.2594 15.0659 3.57914 +7039 4 7.94553 18.1226 5.84491 19.4684 -9.25267 2.2845 +7040 4 9.55198 17.9922 5.98984 -15.4384 -2.82622 -0.0668602 +7041 6 29.8338 10.9771 14.4736 2.85583 -20.8689 4.17621 +7042 4 29.3487 11.4359 13.7779 -2.35633 12.0716 2.99849 +7043 4 29.9333 11.5067 15.2792 -5.11986 9.15119 -1.36774 +7044 6 48.7176 10.2992 32.5766 37.752 -4.2965 -7.5649 +7045 4 48.6861 9.98692 33.5109 4.36425 8.41374 -15.5521 +7046 4 49.6689 10.1741 32.2115 -43.6207 3.75412 17.6406 +7047 6 8.33261 15.6868 37.8739 25.2856 -16.7599 -34.932 +7048 4 8.10095 16.0156 38.719 -17.2941 17.7495 29.2541 +7049 4 7.84865 16.1686 37.1872 -4.77393 6.83012 10.4818 +7050 6 50.4 3.07893 17.326 6.75193 2.54677 -10.5223 +7051 4 49.8476 3.08454 16.5614 0.0537611 0.514048 -24.7797 +7052 4 49.7563 3.22783 17.9993 -5.52918 6.4504 35.6689 +7053 6 14.6925 38.3995 10.8943 -10.4545 -11.2686 -1.07851 +7054 4 14.3539 38.6226 11.7634 0.533319 14.8424 10.3104 +7055 4 14.2274 37.5681 10.7419 5.82896 -0.087222 -8.72758 +7056 6 34.1157 6.37736 10.827 20.4112 17.5403 9.63945 +7057 4 34.1356 7.15575 10.2337 -4.79421 -13.4894 2.09643 +7058 4 34.9392 6.47467 11.3721 -17.4677 -2.57189 -8.67394 +7059 6 7.16428 37.5549 17.6272 35.8206 -6.94283 1.42456 +7060 4 8.17672 37.4379 17.5039 -45.4701 3.04153 9.54579 +7061 4 6.9329 37.0909 18.4673 4.48983 7.2965 -12.9876 +7062 6 51.5173 11.3068 16.7982 -29.6345 12.4732 -19.9425 +7063 4 52.2329 10.8476 17.1999 24.0623 -16.8016 7.00331 +7064 4 51.4947 11.1437 15.8343 5.46468 -1.37513 9.57578 +7065 6 15.6604 8.64432 3.1895 3.55656 -13.2601 -18.336 +7066 4 15.3831 9.26805 3.84437 -11.3932 20.6181 15.5674 +7067 4 16.2117 8.03967 3.68493 6.317 -8.49687 -0.892024 +7068 6 5.4241 21.4549 11.925 7.11554 10.6798 -7.02681 +7069 4 5.33432 22.3429 11.4717 -4.65036 -17.889 17.4658 +7070 4 4.77116 21.2815 12.6313 -0.367847 15.68 -7.67111 +7071 6 50.1893 24.0442 37.9781 -13.1484 0.855785 -17.0816 +7072 4 49.5179 24.1845 37.2801 8.13829 0.111989 16.6227 +7073 4 50.739 23.3224 37.6715 2.2014 -1.01472 3.1635 +7074 6 39.7382 11.2507 31.6977 23.6406 7.23187 -3.58891 +7075 4 40.4046 11.8538 31.2923 -18.8268 -10.2166 5.80002 +7076 4 38.8713 11.6238 31.5229 -1.54541 8.70996 -4.13134 +7077 6 26.6923 10.8294 20.5841 1.50171 17.3672 -0.163562 +7078 4 26.3063 11.3901 21.299 5.00814 -17.7696 -11.6362 +7079 4 26.5519 9.91114 20.8376 -1.99146 -0.979444 5.82041 +7080 6 12.5744 17.5779 18.1705 9.62673 -31.396 -11.9521 +7081 4 12.2909 16.663 17.987 19.11 1.74385 -8.92353 +7082 4 11.8345 17.8227 18.6757 -30.0259 29.7826 25.4081 +7083 6 47.7778 31.6094 17.3292 -7.10666 -17.038 -8.06235 +7084 4 48.347 31.2547 18.014 2.28217 1.30733 4.94459 +7085 4 47.3418 30.8212 16.9416 1.10301 17.3121 -1.07651 +7086 6 1.06524 3.39018 18.5298 -14.3894 10.3619 10.5476 +7087 4 1.40487 3.81402 19.3241 14.4239 4.64695 -0.395869 +7088 4 0.13491 3.28998 18.7837 -2.56119 -4.67364 -10.5163 +7089 6 26.5953 20.387 15.3121 4.86749 -24.5982 -5.101 +7090 4 27.0693 19.5476 15.0746 -6.18915 17.8108 6.48343 +7091 4 25.6882 20.059 15.4501 7.15985 4.40883 -1.86988 +7092 6 42.0068 3.03472 36.7639 -8.02624 -14.3838 3.82934 +7093 4 41.5138 2.21919 36.6422 -1.8797 -9.24856 -19.1073 +7094 4 41.9017 3.12445 37.6992 6.42334 14.3979 20.8626 +7095 6 39.3283 22.4329 33.1866 16.7976 22.9312 16.1168 +7096 4 39.617 22.6043 34.1233 -9.1007 -15.4059 -24.4851 +7097 4 39.2996 23.351 32.8579 -1.9326 -13.3537 -7.72798 +7098 6 18.5014 34.9723 11.9503 -40.872 8.93582 -22.0032 +7099 4 19.313 34.895 12.3871 37.9781 -3.12322 33.9295 +7100 4 17.8134 35.1232 12.6133 -0.0311416 1.40314 8.7121 +7101 6 22.862 14.1089 0.203393 17.2545 -2.37957 19.5806 +7102 4 23.1276 14.8054 41.5255 0.219481 9.03583 -13.3452 +7103 4 23.4003 14.3117 0.999915 -8.23864 -6.67581 -7.59618 +7104 6 30.9898 16.6325 33.7811 -26.24 4.82889 -18.7278 +7105 4 30.4991 16.9295 32.9906 -1.06726 -7.21679 15.5744 +7106 4 31.8724 16.8786 33.545 20.2345 1.84197 6.64809 +7107 6 28.4142 35.5086 5.55132 5.25795 11.5001 -0.86936 +7108 4 29.133 34.8901 5.6729 7.87573 -11.0207 0.32142 +7109 4 28.8444 36.3678 5.44284 -5.96253 -1.38672 0.306744 +7110 6 2.06178 31.4487 10.6522 7.7724 2.5252 5.43788 +7111 4 2.46787 32.1741 10.1582 1.48866 -1.05725 0.00513454 +7112 4 1.12423 31.5492 10.4902 -10.7705 -1.69396 -4.48797 +7113 6 5.96168 9.75465 21.3469 -3.89643 8.81348 -50.5901 +7114 4 6.28958 10.5041 20.7544 -9.04712 -29.7196 22.9081 +7115 4 5.37557 9.21645 20.7377 15.5825 17.9805 22.1648 +7116 6 24.7784 26.6095 2.66066 11.1746 -2.24162 5.28408 +7117 4 23.9956 26.7754 2.10108 -2.29597 -10.0774 9.56872 +7118 4 24.6953 25.8682 3.30791 -10.2989 11.7132 -14.8816 +7119 6 45.7373 4.24983 18.6143 27.3178 -0.763462 -4.2154 +7120 4 46.5067 4.85242 18.4954 -19.0177 -2.03966 3.70694 +7121 4 46.1538 3.38182 18.4484 -14.6954 3.88493 3.6473 +7122 6 4.46307 0.776675 15.9004 -0.0751459 19.7124 -7.24544 +7123 4 4.28648 41.7452 15.8506 7.90268 -11.6504 4.49907 +7124 4 5.34722 0.941656 16.2766 -7.84 -9.44871 -1.18019 +7125 6 2.43543 19.4835 25.3975 -8.02289 7.34849 22.5637 +7126 4 1.8039 19.0427 26.0095 9.34608 -2.48106 -16.7091 +7127 4 2.63666 18.9452 24.6346 -2.8512 -10.1259 -3.82486 +7128 6 40.5893 8.48301 5.11314 -1.35782 -12.8068 -2.32465 +7129 4 40.7524 9.27543 5.61119 -3.30667 17.7402 10.4879 +7130 4 41.4486 8.05286 5.16027 3.34022 -8.8045 -8.92488 +7131 6 49.3107 22.3512 41.5276 -10.6582 56.3201 6.76971 +7132 4 48.577 22.7852 41.0387 15.264 -8.60422 5.01334 +7133 4 49.2575 21.458 41.2835 -0.448838 -46.7272 -11.6484 +7134 6 0.358901 40.9209 20.5803 -19.8443 -5.20423 -21.0143 +7135 4 0.209912 39.9476 20.5616 0.00996972 10.506 -0.843682 +7136 4 54.6254 41.351 20.0384 15.1519 -13.0167 14.2251 +7137 6 34.868 15.3449 38.0159 -4.77394 11.9701 -21.6163 +7138 4 34.21 16.0699 37.905 14.1938 -11.5268 -7.28032 +7139 4 35.478 15.4115 37.2329 -18.0572 6.07255 16.3223 +7140 6 7.76403 26.0071 29.8556 5.34791 -0.957035 4.21351 +7141 4 8.62364 26.4528 30.0224 -8.82329 -12.5157 -0.945539 +7142 4 7.90301 25.0604 30.0866 1.23738 19.4493 -2.25897 +7143 6 40.714 22.798 20.4449 30.2403 28.6605 -20.1452 +7144 4 41.3584 23.4838 20.081 -22.4198 -29.1089 11.875 +7145 4 40.2102 23.3285 21.0558 -12.075 4.18803 12.4472 +7146 6 37.6868 25.6422 36.0641 6.66209 -5.59755 13.6904 +7147 4 38.2808 24.8923 36.0269 4.65063 -3.44496 7.57849 +7148 4 37.3429 25.6351 35.1859 -16.0941 8.70932 -25.1352 +7149 6 5.45062 23.9828 10.2587 5.16865 5.9624 5.01697 +7150 4 5.97911 23.8188 9.45867 -6.21725 4.51436 8.29683 +7151 4 5.82702 24.8173 10.6422 -10.2102 -24.7042 -13.9856 +7152 6 48.3972 21.0585 38.1887 36.079 14.8531 -15.9941 +7153 4 48.9083 20.6932 38.9203 -9.15007 -3.24726 4.47194 +7154 4 49.1186 21.3212 37.5505 -33.8036 -6.43701 14.9947 +7155 6 15.2894 25.0118 3.53737 -15.5341 -16.8072 10.9824 +7156 4 15.3523 24.0463 3.54635 7.80908 -0.218079 -10.1213 +7157 4 14.6524 25.152 4.25109 -0.971191 12.1275 -1.41446 +7158 6 46.3973 40.2818 20.0864 -5.10979 -28.8528 0.810189 +7159 4 46.7099 39.3289 20.1836 -4.69047 35.7762 -3.66479 +7160 4 47.1343 40.8792 20.2285 11.4236 3.93541 -0.385178 +7161 6 34.6613 36.4755 0.335066 -24.7851 30.4749 -21.6933 +7162 4 34.8743 36.0541 1.15687 -4.43901 -4.57192 24.0914 +7163 4 33.7851 36.9546 0.454416 30.1492 -20.7825 2.99091 +7164 6 52.5881 7.99834 30.4195 9.51271 -12.4348 0.483116 +7165 4 52.1042 8.76616 30.7719 -8.49213 -7.21741 -10.9068 +7166 4 52.0722 7.46347 29.7764 0.520668 12.6171 10.1624 +7167 6 32.0714 3.86484 29.4697 -9.7538 -17.9077 -31.6249 +7168 4 31.6702 2.97314 29.6052 7.93851 20.6113 2.31556 +7169 4 32.0839 3.94733 28.4741 0.539668 -3.17995 32.4864 +7170 6 20.3786 17.8365 28.6466 -12.59 16.0252 -12.2548 +7171 4 19.5397 17.5939 29.0718 10.0495 1.57584 1.91854 +7172 4 20.0545 18.3008 27.843 10.529 -6.18443 10.1885 +7173 6 30.4085 41.1704 41.0135 6.18506 -3.22706 -14.2809 +7174 4 30.53 40.7341 40.1581 -10.3332 2.11637 -0.589059 +7175 4 31.2241 40.9477 41.4498 10.7912 2.88832 12.9661 +7176 6 35.4567 32.8541 27.9296 20.1033 20.3116 -25.2142 +7177 4 35.1103 33.2872 28.7174 -1.27312 4.66796 4.01126 +7178 4 35.9087 33.5476 27.342 -15.0191 -24.2746 21.4934 +7179 6 14.3794 6.67806 12.7301 -1.9413 28.2373 -4.00169 +7180 4 15.2373 6.26429 12.8613 2.01848 -2.11516 -0.858514 +7181 4 14.5332 7.65903 12.7289 -3.54891 -27.4927 -2.87641 +7182 6 41.884 41.5441 20.3292 17.5267 3.97767 -7.39307 +7183 4 42.6467 41.3531 19.7473 -6.80228 5.43899 6.41045 +7184 4 41.2989 40.8038 20.1922 -8.54368 -4.96293 -3.75352 +7185 6 46.4016 22.5784 8.86191 7.75251 -10.6521 7.11129 +7186 4 45.8476 21.8716 8.52158 -12.3576 2.35246 -8.51817 +7187 4 47.0146 22.0703 9.39636 1.75986 6.35736 5.22437 +7188 6 17.4049 20.6472 13.8946 9.03444 14.2526 1.49725 +7189 4 17.6929 21.5842 14.0543 -8.3446 -25.4959 -7.46489 +7190 4 17.3265 20.4984 12.9333 2.034 6.01629 5.63707 +7191 6 8.18883 9.49722 13.352 -36.2403 7.79383 -0.838203 +7192 4 7.38606 10.0563 13.5919 32.9103 -12.129 -3.09847 +7193 4 9.02271 9.90793 13.6245 -5.40631 9.4956 5.41337 +7194 6 7.5857 14.8045 29.5864 0.660595 8.18183 -2.22865 +7195 4 7.08502 14.4366 30.3218 -1.52277 2.83209 3.37304 +7196 4 7.02502 15.474 29.1565 2.15616 -5.78955 1.98978 +7197 6 29.5787 39.2199 22.642 -23.9064 2.77655 4.40715 +7198 4 29.7923 38.7231 23.4359 12.3113 -5.95711 5.92816 +7199 4 30.3289 39.2945 22.0576 16.6647 -3.01011 -3.30282 +7200 6 19.7261 28.8048 8.43629 7.07867 10.1416 -1.30332 +7201 4 19.5094 27.8711 8.56662 5.24428 2.50367 -2.7317 +7202 4 20.6808 28.8901 8.64157 -12.3267 -4.04756 -0.658665 +7203 6 20.0918 21.6433 25.9098 -22.8378 18.9737 -2.62589 +7204 4 20.6828 21.9331 26.6394 -14.5657 0.991195 -11.6344 +7205 4 19.2872 22.2354 25.9429 24.6623 -16.2361 5.64257 +7206 6 12.7798 16.1171 22.7918 2.83481 -1.66518 -8.4999 +7207 4 12.1052 16.761 22.5802 -5.26913 11.1277 0.000470885 +7208 4 12.4145 15.3113 22.3987 5.67676 1.62415 3.74644 +7209 6 7.09341 27.2127 17.9852 -17.6727 17.6357 -2.43489 +7210 4 7.71878 26.5086 17.8851 15.5779 -18.3258 -2.50971 +7211 4 7.24623 27.7931 17.2297 2.82114 0.873921 -0.89624 +7212 6 32.4121 8.69011 34.8574 -11.3856 31.068 25.9423 +7213 4 32.686 9.10208 35.716 -2.62469 -14.8204 -24.695 +7214 4 31.4981 9.04705 34.7249 20.8054 -13.4625 -4.53694 +7215 6 50.3489 28.2274 17.5408 2.96892 -19.9668 3.87059 +7216 4 50.2931 27.3328 17.9381 -3.71715 13.2344 -0.552608 +7217 4 51.012 28.0828 16.8476 -2.81747 8.99858 -3.49204 +7218 6 15.6752 32.1523 25.7996 -24.1097 -1.02752 -8.0065 +7219 4 16.4469 32.5721 26.1513 19.1192 7.47953 7.03048 +7220 4 15.1241 32.8942 25.4834 5.39501 -5.59697 3.80799 +7221 6 41.2942 22.0009 29.6469 23.8016 -11.3242 12.4312 +7222 4 40.6197 22.5451 29.2897 -20.6362 19.5621 -14.8771 +7223 4 40.8321 21.2604 30.0334 -1.27155 -6.80964 4.85239 +7224 6 24.5512 12.7478 8.87624 0.539479 -2.56763 -16.1827 +7225 4 24.2317 13.5544 9.29419 1.48927 0.294937 0.678301 +7226 4 24.2485 12.8104 7.9491 4.47413 -5.17195 11.4459 +7227 6 47.3043 20.1171 10.4067 20.0451 13.2477 8.4905 +7228 4 48.2327 20.3756 10.3708 -0.951507 4.56311 9.88278 +7229 4 47.2371 19.5522 9.64912 -14.6685 -17.4861 -17.2657 +7230 6 17.6686 14.2187 29.9453 7.31834 -6.07886 -8.28437 +7231 4 16.8567 14.6777 30.1627 -12.3548 11.6861 -0.426412 +7232 4 18.1621 14.7508 29.3045 -6.68566 0.573373 4.02912 +7233 6 21.3468 34.5864 28.5404 1.3464 21.7174 -7.002 +7234 4 21.5866 35.4807 28.2285 -6.04705 -7.23946 1.73439 +7235 4 21.8012 34.5133 29.372 6.90897 -8.71765 12.9147 +7236 6 35.0919 4.05058 4.01374 -15.5825 9.30565 11.5721 +7237 4 34.2387 3.74233 4.43927 22.4566 16.9059 -11.4445 +7238 4 35.1406 5.04582 3.93988 -11.3656 -25.7387 7.52347 +7239 6 29.9083 8.58745 22.5962 -15.8002 1.46007 -28.7439 +7240 4 29.4293 8.33193 21.7391 23.5037 3.33824 36.5279 +7241 4 30.4512 7.83881 22.8901 -6.5033 3.48596 -7.29863 +7242 6 9.80484 32.9578 15.933 -3.40746 -8.77641 -12.0557 +7243 4 9.78146 31.9986 16.1651 13.0086 23.7442 4.23133 +7244 4 10.4547 33.4728 16.4465 2.19651 -19.1398 5.78046 +7245 6 24.9207 14.2283 32.5839 15.8568 -2.03515 22.8032 +7246 4 25.4679 14.491 33.3602 -10.7028 -6.65113 -14.6818 +7247 4 24.5651 15.0495 32.2637 -5.99659 7.67207 -7.30645 +7248 6 49.6599 21.9679 26.2292 42.3899 27.0609 3.31449 +7249 4 50.4576 21.5325 26.6526 -24.3124 13.7703 -9.69582 +7250 4 49.9726 22.89 25.9802 -16.6307 -33.6109 8.97028 +7251 6 39.2146 29.6271 28.776 1.2649 -6.72815 -4.66326 +7252 4 39.3113 29.0399 29.5368 -1.10705 1.67847 4.24024 +7253 4 39.5646 29.0864 28.052 -0.275695 2.9096 0.748968 +7254 6 50.692 34.7829 39.7485 29.9384 -8.83369 -9.14761 +7255 4 51.6379 34.6172 39.5245 -10.9597 10.0847 13.0799 +7256 4 50.284 34.1892 39.1195 -14.598 -6.88033 -5.74908 +7257 6 29.205 20.8761 19.5187 12.6622 -8.88768 18.517 +7258 4 30.1458 21.1462 19.5468 -10.0278 2.51211 -7.13483 +7259 4 28.7621 21.2804 18.7794 -5.02457 12.868 -15.5739 +7260 6 45.8413 1.41619 21.3894 -25.1775 13.0352 -19.0829 +7261 4 45.002 1.0285 21.6935 10.996 -3.183 3.42833 +7262 4 46.5512 0.981978 21.8333 16.3199 -17.0363 14.4799 +7263 6 26.0942 5.84138 12.9755 -8.81801 -1.79204 -2.94978 +7264 4 26.5644 5.00851 12.8396 1.48472 -6.22175 2.21387 +7265 4 25.1658 5.65249 12.7519 4.56693 -2.33816 -1.27821 +7266 6 9.00853 19.0479 23.7214 20.279 18.3012 -13.9253 +7267 4 8.07192 18.8993 23.8406 -12.3386 2.44029 -0.494901 +7268 4 9.09287 19.8709 23.17 -6.05991 -16.4473 11.9144 +7269 6 47.699 14.1778 40.0244 8.37408 5.46764 -8.11648 +7270 4 48.526 14.369 39.5365 -13.6583 -0.0280305 9.55934 +7271 4 47.2742 15.0291 40.2237 1.48315 -6.20176 -4.56159 +7272 6 47.9891 19.7944 0.501942 -52.5058 -34.5194 5.9677 +7273 4 48.5389 19.8149 1.25758 31.4646 9.24384 22.8657 +7274 4 47.3233 19.1101 0.79406 16.1078 24.936 -21.6052 +7275 6 27.1644 39.5895 31.4222 -35.4984 -42.2857 -13.2745 +7276 4 26.8828 40.2644 32.0188 2.45392 19.408 13.0965 +7277 4 26.334 39.0158 31.3353 32.2444 14.87 -2.1562 +7278 6 20.718 15.281 27.2921 -20.5288 29.0824 -25.1338 +7279 4 19.7916 15.5288 27.1303 0.0426049 -12.6319 11.5337 +7280 4 21.1251 16.0883 26.9354 13.4588 -8.377 2.43969 +7281 6 53.2931 3.12982 19.6939 21.059 35.3193 6.93312 +7282 4 52.5111 3.68486 19.642 -0.600406 9.66435 -1.15328 +7283 4 52.9649 2.26115 19.6482 -6.97037 -43.0252 -2.92507 +7284 6 40.7577 33.3874 24.037 12.7176 -1.25655 15.6318 +7285 4 41.575 33.1492 24.5319 -10.6485 3.51614 -11.0419 +7286 4 40.1417 32.64 24.1417 6.01104 2.31945 0.566227 +7287 6 50.2034 37.8915 21.3784 34.5696 42.4783 -9.46203 +7288 4 50.977 37.3667 21.5595 20.6596 -6.9612 4.63629 +7289 4 49.5128 37.3071 21.51 -51.1752 -39.6198 7.18684 +7290 6 41.3315 2.34663 21.9881 -5.34027 -0.787955 22.4754 +7291 4 41.3778 2.5308 21.0564 -4.51788 5.59338 -11.8441 +7292 4 40.4369 2.61524 22.307 16.348 -5.18373 -12.1741 +7293 6 3.68887 21.2797 14.3363 -13.7249 24.7693 -29.296 +7294 4 4.1389 21.9084 14.895 6.09004 12.6164 9.74183 +7295 4 3.85532 20.4521 14.7268 10.1618 -35.5887 19.7816 +7296 6 34.2749 11.1621 36.6211 6.86722 -26.3475 -8.98455 +7297 4 34.1457 10.3739 37.2084 1.76529 18.7936 -6.49638 +7298 4 34.0208 11.9523 37.0887 -10.0392 4.20616 19.2695 +7299 6 24.047 21.9251 23.4534 9.96695 -9.01801 9.45846 +7300 4 24.1056 21.4984 22.592 0.489969 -1.19981 -5.95122 +7301 4 24.6049 21.3417 24.0221 -10.3198 12.7259 -7.25629 +7302 6 18.8859 0.355593 4.41703 6.91373 -0.488994 13.8226 +7303 4 18.8848 41.346 4.15992 -3.4937 -3.21088 -8.69706 +7304 4 19.4141 0.350836 5.23016 -4.89519 7.76131 -7.17368 +7305 6 1.61894 7.82812 17.7388 11.0013 -2.20401 0.0755565 +7306 4 1.69825 6.91132 17.4299 0.598176 5.44338 0.144381 +7307 4 0.751076 7.92867 18.1276 -6.88769 -1.80246 0.772288 +7308 6 9.88357 31.5477 26.4865 20.7425 -47.9078 -25.9665 +7309 4 9.77347 30.8406 25.7562 4.13802 32.2768 29.9214 +7310 4 9.16637 32.1481 26.416 -28.5637 22.827 -5.6847 +7311 6 46.9801 33.0031 20.3665 8.92807 -2.6835 25.0439 +7312 4 47.1906 32.5959 21.2783 -12.5238 7.50902 -41.0074 +7313 4 46.473 32.3868 19.8049 3.08737 -2.68707 12.6131 +7314 6 49.5381 29.29 21.3848 5.35466 4.48298 6.61079 +7315 4 50.3596 28.8237 21.4263 11.6576 -22.6485 -14.6982 +7316 4 49.6544 29.7814 22.1942 -19.8316 15.0268 8.13943 +7317 6 13.5135 31.8933 19.1567 20.4477 19.0535 18.7588 +7318 4 12.9544 32.0303 19.9484 11.7182 -3.51681 -10.2564 +7319 4 14.3688 32.3555 19.4049 -26.6747 -15.4769 -10.5401 +7320 6 46.6242 34.0973 16.9259 3.25439 -22.1556 18.333 +7321 4 46.8986 34.1178 16.0034 3.18051 -0.659651 -5.23437 +7322 4 46.9878 33.2447 17.2966 -6.98741 23.2488 -14.973 +7323 6 19.7685 39.5238 2.42723 -1.93992 9.56528 -9.07466 +7324 4 20.504 40.1421 2.55739 -2.20075 -2.41675 -0.557551 +7325 4 19.2228 39.9982 1.75695 7.86662 -14.3322 13.7479 +7326 6 16.5372 9.39399 28.3106 5.81076 4.55242 0.698497 +7327 4 16.5228 10.3583 28.3138 -6.10914 3.2393 2.1867 +7328 4 17.4567 9.2086 28.1181 8.68803 -11.6531 -1.09187 +7329 6 3.04764 33.3834 8.9498 9.15555 8.47462 14.2626 +7330 4 2.34782 34.0603 8.86882 1.18173 -6.7492 -12.1187 +7331 4 3.16543 32.8691 8.13996 -9.91006 6.39371 -6.60301 +7332 6 49.6799 28.314 0.198287 -24.1009 9.02482 3.02524 +7333 4 50.5864 28.3416 41.8577 25.8797 -1.22492 -6.2647 +7334 4 49.539 27.5375 0.746128 -0.431885 -1.84115 5.43874 +7335 6 1.41501 6.84656 30.491 -4.80497 13.9866 22.936 +7336 4 1.80101 7.66454 30.873 3.64878 -10.2221 -13.1962 +7337 4 0.770406 6.61566 31.1883 9.6026 -0.286793 -13.8716 +7338 6 19.7721 9.41455 33.714 -8.86768 10.4812 -29.5452 +7339 4 19.9336 8.45599 33.7164 -2.74186 3.51224 -8.50186 +7340 4 19.4649 9.70036 32.7878 8.54711 -12.9815 34.2723 +7341 6 26.1689 11.9219 3.60877 17.3014 14.1658 -18.8808 +7342 4 25.6285 12.278 4.29668 -11.0155 5.7348 17.6305 +7343 4 26.0891 10.974 3.64129 -4.70103 -13.8965 4.54114 +7344 6 33.2526 2.15457 18.2061 -11.4346 36.8522 -3.73875 +7345 4 32.7853 2.99777 18.4754 10.6797 -23.9754 -11.6278 +7346 4 32.6748 1.45157 18.4903 -6.58847 -5.37306 4.71859 +7347 6 1.56641 29.1164 15.6218 -13.5802 38.9916 52.9136 +7348 4 0.75332 28.6899 15.9164 -2.28927 1.65734 -1.12046 +7349 4 1.88381 28.6368 14.9104 18.6776 -39.2188 -53.7174 +7350 6 41.7212 4.09992 39.5909 -11.2791 25.9615 -27.213 +7351 4 41.4168 4.81457 38.9155 6.653 -41.6332 33.8875 +7352 4 40.9635 3.53859 39.8438 1.60091 7.46224 -7.31473 +7353 6 28.6931 41.7984 21.1891 -6.68751 -8.42641 -4.80462 +7354 4 29.0735 0.780303 21.3271 9.25035 -16.558 -3.13259 +7355 4 29.3834 41.1221 21.0106 -2.7364 22.7931 4.70591 +7356 6 11.6395 12.4176 35.4525 -19.931 13.6599 -6.89173 +7357 4 11.6974 12.2316 36.3791 0.0383878 -4.43782 22.0781 +7358 4 12.5438 12.3774 35.1867 22.2579 1.64914 -11.6458 +7359 6 9.79005 12.0613 0.287125 39.0331 19.741 15.6941 +7360 4 10.6741 12.3652 0.649112 -24.288 -6.9143 -28.8601 +7361 4 9.37178 11.7496 1.07064 -16.9981 -12.0004 12.0483 +7362 6 48.1738 12.4001 9.21087 -14.7098 16.6281 -3.51107 +7363 4 48.3046 11.757 8.50338 5.36034 -5.93883 0.971929 +7364 4 48.886 12.3441 9.8545 11.7295 -7.72549 2.46367 +7365 6 20.1355 24.3829 18.9522 12.9308 -0.734849 -39.1055 +7366 4 19.4937 23.7815 18.5135 12.9255 8.80461 9.87411 +7367 4 20.8069 24.6162 18.234 -21.1698 -7.06963 26.7537 +7368 6 16.5393 31.2961 16.4761 -1.92172 -19.5246 -12.7122 +7369 4 16.66 32.2288 16.679 -4.64409 4.5232 17.4599 +7370 4 16.1207 30.7474 17.1716 1.36469 17.4989 2.94612 +7371 6 1.78169 14.6393 36.2977 19.9207 14.6923 -9.09136 +7372 4 1.03986 14.2937 35.8105 -15.9251 -7.35249 0.645581 +7373 4 1.68132 14.4688 37.2355 -8.64532 -4.94464 12.0587 +7374 6 4.36624 29.2084 29.5903 15.7403 17.1522 -11.4447 +7375 4 4.94475 28.7816 30.2313 0.42296 -3.8665 4.22363 +7376 4 4.9316 29.8996 29.1557 -19.5902 -17.4666 6.54186 +7377 6 43.6839 0.248111 22.6506 -19.7732 -13.3298 -9.50689 +7378 4 42.8764 0.661685 22.3065 0.028666 2.48852 1.60322 +7379 4 43.5183 41.2016 22.5042 11.2477 10.9397 1.57875 +7380 6 52.4994 40.9828 27.2386 -0.538127 -6.12089 -28.931 +7381 4 52.76 40.8447 26.286 -9.02638 3.90908 21.7421 +7382 4 53.2684 41.4137 27.6303 2.05735 4.02476 1.85103 +7383 6 25.5814 23.8969 27.7396 -24.7861 2.98762 0.531627 +7384 4 24.718 24.3642 27.6072 20.4038 -13.4527 4.15226 +7385 4 26.2821 24.4835 27.457 3.8963 1.45656 -1.88052 +7386 6 23.1228 17.031 33.3243 -5.52517 1.23961 5.4323 +7387 4 23.1399 17.5083 34.1558 0.441881 0.23205 -0.480567 +7388 4 22.8557 16.1383 33.5546 -4.67547 -8.64305 1.56256 +7389 6 2.92722 11.8725 21.3561 -41.4423 -19.1296 -19.7046 +7390 4 2.18606 11.2638 21.6443 29.5918 21.1066 -8.34803 +7391 4 3.54191 11.9259 22.0595 17.1072 -0.484489 21.5157 +7392 6 2.18317 4.15265 30.0257 5.779 -9.3787 -10.7468 +7393 4 2.12921 5.11001 30.0802 -2.76576 12.2821 -0.843831 +7394 4 2.67493 3.96573 29.2018 -3.29095 2.88479 4.98522 +7395 6 26.6728 30.2949 13.4768 7.17255 0.654769 14.1147 +7396 4 25.7117 30.2905 13.6467 8.22624 -2.44269 3.31295 +7397 4 27.1112 30.3188 14.3546 -11.9073 -0.623098 -17.8849 +7398 6 24.8734 30.8117 10.8292 -29.6944 -3.60301 -2.53615 +7399 4 25.2254 30.0431 10.3884 7.40196 -6.71761 -6.36825 +7400 4 25.5983 31.2424 11.2381 22.0508 11.6497 12.6203 +7401 6 53.1723 24.107 4.51212 -8.50651 -29.3458 16.902 +7402 4 53.5087 24.8189 4.00388 11.9327 21.9784 -14.7749 +7403 4 53.9335 23.6869 4.92936 2.49868 2.30602 2.88115 +7404 6 24.9006 4.49574 23.9943 -15.2803 12.8054 -1.91421 +7405 4 24.3197 5.26112 23.9044 -17.3839 -11.7779 6.16284 +7406 4 25.6928 4.95696 23.7819 42.3091 -2.82475 -3.31223 +7407 6 34.6808 1.64534 41.2582 -1.16689 -16.4189 -19.1193 +7408 4 35.6107 1.42238 41.0689 -7.35569 3.11738 8.02352 +7409 4 34.6894 2.06091 0.199506 5.11707 10.3461 19.9542 +7410 6 13.3318 19.5273 16.3875 10.456 -31.2285 9.008 +7411 4 13.8245 19.0713 15.6714 -4.89067 6.02882 4.66139 +7412 4 13.1633 18.7854 17.0362 1.8233 23.0525 -16.1268 +7413 6 48.6827 0.169575 20.4108 24.7259 -31.926 -14.6767 +7414 4 49.2893 41.6148 19.7702 -18.6338 21.3246 17.3218 +7415 4 48.933 41.6689 21.2514 -6.5025 5.85221 0.333279 +7416 6 43.0578 27.7881 11.5189 -10.6888 1.76469 -10.0665 +7417 4 42.6538 28.0077 10.6554 5.1393 -6.0393 10.108 +7418 4 43.5199 28.5835 11.7935 3.33621 0.984046 2.36511 +7419 6 25.7084 21.3766 35.1933 7.92601 18.71 -2.37973 +7420 4 25.8037 22.0957 34.5091 -5.30878 -22.9017 16.0752 +7421 4 25.4462 20.5484 34.7558 3.58761 11.0813 -0.636196 +7422 6 44.7325 4.60288 27.7529 -5.18995 0.47983 -9.95788 +7423 4 44.2388 4.02478 27.1463 1.34738 -4.40857 1.63455 +7424 4 44.3371 5.47709 27.6067 3.7052 -1.13476 4.16529 +7425 6 41.2786 11.441 34.2043 -0.416747 21.9122 -5.07112 +7426 4 40.7165 11.5703 33.4237 0.0697438 -4.14349 0.395824 +7427 4 41.2047 10.5155 34.4107 -4.51201 -19.8544 2.93408 +7428 6 19.8751 36.6454 2.03332 12.5662 31.6724 6.60432 +7429 4 20.6794 36.321 2.43856 -1.22315 -24.7147 -1.51883 +7430 4 20.0441 37.6041 2.15193 -20.0718 -8.75186 -9.57731 +7431 6 27.484 4.65653 6.35518 1.28922 -40.4385 -58.6648 +7432 4 27.5497 3.77116 6.72735 -1.75384 3.56143 11.9553 +7433 4 27.4257 5.33486 6.97498 -2.79123 31.4549 44.9969 +7434 6 16.8428 30.7659 39.9509 7.31092 -42.6244 -5.47757 +7435 4 16.9464 31.3097 40.7337 2.60533 1.47109 13.0941 +7436 4 17.1496 29.8303 40.1512 -5.48449 28.5555 1.20442 +7437 6 51.1542 15.2049 16.3406 35.1838 19.4064 -24.6303 +7438 4 51.2473 16.0791 15.87 -9.06363 -20.4986 13.944 +7439 4 52.0128 14.747 16.0894 -33.4595 8.32861 13.6861 +7440 6 49.9911 21.2271 35.9695 16.4294 -24.4585 13.2328 +7441 4 49.3547 21.5056 35.3276 -17.8928 6.13619 -17.6667 +7442 4 49.9245 20.2453 36.0087 2.29216 20.3869 -1.95357 +7443 6 34.4275 0.15221 5.68266 -0.837995 23.3079 0.855413 +7444 4 34.2957 0.929489 6.27037 2.93096 -11.6463 -16.4536 +7445 4 34.3488 0.459476 4.74482 0.623699 -7.30698 18.2278 +7446 6 48.316 11.5365 19.8846 -3.65813 -3.14803 11.8504 +7447 4 47.8503 11.3247 20.7373 6.31016 14.4835 -28.1035 +7448 4 47.7834 12.1052 19.2757 1.33379 -13.4076 20.6299 +7449 6 4.19577 39.4409 13.3607 25.3524 9.34899 10.5928 +7450 4 4.92582 39.74 13.9847 -33.0668 -7.48624 -17.3574 +7451 4 3.31127 39.5736 13.758 11.9971 1.78205 4.76714 +7452 6 8.7457 16.1809 8.53298 -1.62633 17.1572 -22.0575 +7453 4 8.74512 16.8853 9.19115 0.0519099 -7.3494 1.25428 +7454 4 8.72812 16.6658 7.66651 -0.023414 -16.7756 16.7144 +7455 6 29.0271 14.2712 26.5342 -13.8591 45.9397 20.1216 +7456 4 29.0757 15.2697 26.7309 6.93185 -43.1811 -12.6551 +7457 4 28.1042 14.0702 26.7795 9.9397 -3.04712 -3.53591 +7458 6 27.3813 14.5204 8.1419 -14.0666 1.8718 0.247246 +7459 4 26.4091 14.3966 8.10069 17.9482 5.30051 2.04476 +7460 4 27.5539 15.4689 8.31094 -4.76419 -14.5771 -1.3831 +7461 6 14.1301 27.2156 32.9232 24.3629 15.6041 -10.7258 +7462 4 14.926 27.3266 33.4685 -8.09546 -2.45296 -2.52419 +7463 4 13.4702 26.8045 33.4616 -14.5983 -10.6772 12.2116 +7464 6 31.6563 35.7792 21.2709 -29.1401 -25.1051 5.88501 +7465 4 32.0219 36.5153 21.7512 6.27263 14.1007 6.62418 +7466 4 30.8825 35.462 21.8184 22.9209 7.6802 -13.887 +7467 6 54.2186 28.7134 16.8958 -10.3287 11.0002 2.01575 +7468 4 53.5002 28.4234 16.309 3.24852 -2.61584 3.16662 +7469 4 53.9524 29.6107 17.1726 0.515277 -7.78004 -0.375364 +7470 6 9.0512 5.27483 17.1492 25.6572 1.38615 -17.9054 +7471 4 9.89534 5.12229 16.6101 -31.8522 3.085 22.1798 +7472 4 8.85255 6.23494 17.0921 1.81156 -15.0607 2.57474 +7473 6 29.6868 9.77258 26.5671 22.9889 -14.8503 10.4327 +7474 4 30.5444 9.2887 26.5838 -17.3341 11.3615 1.53321 +7475 4 29.3655 9.78642 27.4819 2.88877 -1.07091 -0.346791 +7476 6 44.0288 31.1766 32.1743 -14.2068 1.02328 22.4178 +7477 4 43.2475 30.9789 32.739 9.50682 -2.17476 -16.522 +7478 4 44.5788 31.7142 32.7564 8.88854 3.82935 -1.95952 +7479 6 53.49 3.62433 25.1454 11.2777 4.02107 -26.8953 +7480 4 54.1404 4.33507 25.1993 -2.49783 6.11479 15.045 +7481 4 53.6886 3.29227 24.2489 -10.294 -6.80459 12.4065 +7482 6 12.451 22.8746 3.38821 10.4278 8.96452 22.9237 +7483 4 12.7779 22.025 3.15024 17.1772 -24.972 1.67394 +7484 4 11.7815 22.9738 2.74712 -31.3784 16.165 -21.5343 +7485 6 39.42 29.6871 0.722943 17.2287 20.3893 -0.939439 +7486 4 39.938 29.1007 0.168548 -5.00448 -5.71086 -1.61555 +7487 4 38.6697 29.2119 1.03517 -14.5725 -11.7208 3.22357 +7488 6 13.7451 37.8179 23.0399 -3.65878 -32.3471 -6.65898 +7489 4 14.6418 38.0465 23.3627 -20.7195 15.519 -6.09735 +7490 4 13.1315 38.5597 22.9108 15.1185 11.2609 5.5967 +7491 6 33.3417 41.2334 -0.000336223 20.2285 27.8942 26.4667 +7492 4 33.8463 0.176253 41.7571 -17.5829 -26.3423 -4.93882 +7493 4 33.4991 41.0748 0.960438 -12.6248 -4.93214 -20.7453 +7494 6 15.7246 3.51737 6.33987 10.6879 -4.05507 31.4744 +7495 4 14.9251 3.29652 6.83809 -1.96505 1.65417 1.3128 +7496 4 15.4345 3.71468 5.4634 -8.944 6.24557 -22.4591 +7497 6 27.7713 30.7539 5.06912 -9.69485 -19.9648 -11.4393 +7498 4 28.5319 30.6575 5.66481 -7.77203 -4.90526 -3.90413 +7499 4 27.6074 29.8515 4.67882 9.36195 16.9347 11.4385 +7500 6 13.3277 7.57287 23.3467 18.1651 -5.37845 17.9429 +7501 4 14.1986 7.86136 23.0073 -11.0143 -2.49266 1.50668 +7502 4 12.7134 7.55433 22.6278 -8.93981 2.52131 -14.7715 +7503 6 38.3049 37.3174 27.9983 8.70135 -12.5747 15.655 +7504 4 38.3154 37.3922 27.0572 -6.74668 8.75695 -30.2201 +7505 4 39.0324 36.7087 28.1704 1.61648 -2.88985 11.5174 +7506 6 35.8266 12.5392 12.0897 -2.57405 -7.53067 12.8361 +7507 4 35.6491 11.5922 12.0112 2.97069 1.46586 -4.70523 +7508 4 36.2655 12.8127 11.2954 6.10525 2.83369 -11.8718 +7509 6 52.1153 23.0889 41.2774 53.3714 4.98692 -14.9993 +7510 4 52.5505 23.0114 40.3503 -31.9828 -2.74691 35.5054 +7511 4 51.1752 22.9201 41.2974 -16.3051 -5.99839 -13.4785 +7512 6 39.5458 11.6586 16.6081 -4.87816 2.10267 -34.9091 +7513 4 39.8889 10.7596 16.6462 4.61035 -3.54577 11.4771 +7514 4 39.4661 12.017 17.4857 2.58954 -3.33375 20.5696 +7515 6 0.680688 9.01153 7.97148 24.3969 36.1639 -33.0882 +7516 4 54.7452 9.01592 8.14854 -24.8099 -10.5681 8.91807 +7517 4 1.15172 8.32837 8.40327 2.66278 -26.2854 21.5078 +7518 6 42.3319 28.747 39.482 14.4944 54.9029 13.7373 +7519 4 41.6099 28.5069 40.0315 -24.977 -16.9351 14.372 +7520 4 42.5658 28.0062 38.9777 10.1954 -37.5926 -27.6332 +7521 6 38.7351 30.2774 16.2793 4.0737 2.19128 11.2593 +7522 4 38.8758 29.8829 17.1681 -0.562728 7.98522 -10.8415 +7523 4 39.3736 31.0181 16.2214 -9.64538 -12.7452 3.65311 +7524 6 7.59373 18.0328 0.655349 -39.2466 -13.429 1.02247 +7525 4 7.12412 17.545 1.38102 15.2508 10.2608 -15.5396 +7526 4 8.49503 18.0746 0.920891 28.7098 -1.69475 13.4339 +7527 6 33.7283 34.5883 24.1367 2.81913 -0.677006 -1.55035 +7528 4 33.5209 35.3543 23.5868 -0.36085 -2.23271 3.31185 +7529 4 34.0202 34.925 24.9956 3.1898 -0.550642 -1.12415 +7530 6 16.0108 40.0553 39.5926 -11.937 1.54577 -14.812 +7531 4 16.9471 40.1686 39.433 15.7688 -0.191962 4.71606 +7532 4 15.632 40.0274 38.6953 -1.55756 -1.47356 6.94311 +7533 6 4.49381 37.1265 21.8421 33.1234 -31.7004 -39.5319 +7534 4 4.78916 37.7556 22.4729 8.60512 21.3704 21.7375 +7535 4 5.32421 36.8863 21.3047 -36.9575 7.65083 16.8008 +7536 6 39.2568 20.1405 31.3294 -11.3601 -2.01094 -17.3558 +7537 4 39.2441 20.8952 31.9186 1.64276 10.2876 11.6417 +7538 4 38.6708 20.3662 30.5789 5.24327 3.39586 9.04201 +7539 6 28.5615 6.15748 32.0463 -1.77815 -13.6106 -5.56393 +7540 4 29.3688 6.39317 32.5024 4.03477 3.32162 5.90581 +7541 4 28.0645 6.97719 31.936 3.86184 3.53187 3.02469 +7542 6 9.32925 11.326 38.2021 -45.7357 8.82179 -18.9514 +7543 4 8.63026 12.0506 38.2047 26.1946 -20.5574 6.08922 +7544 4 8.95275 10.6938 37.5333 17.8336 11.1262 12.3014 +7545 6 41.6094 10.4714 6.86105 10.1449 -2.02989 30.4141 +7546 4 41.8033 10.1647 7.80154 -6.16714 11.7455 -31.3638 +7547 4 41.7667 11.4361 6.82819 -2.03628 -11.6206 -3.02795 +7548 6 3.11959 28.1093 17.6239 10.7497 -46.175 24.4008 +7549 4 2.68352 28.5892 16.9552 -19.7085 26.1099 -29.6067 +7550 4 3.57016 28.7359 18.1797 1.91623 14.188 4.79643 +7551 6 39.3448 12.237 19.2548 -14.1137 14.4353 18.1644 +7552 4 39.3198 13.2124 19.4672 -0.23776 -25.4214 -5.72266 +7553 4 38.5957 11.8144 19.7397 13.7352 7.639 -10.0067 +7554 6 2.76578 9.12322 31.711 10.2249 -26.7767 20.5709 +7555 4 3.2959 8.42892 32.18 -23.1647 11.967 -1.06293 +7556 4 3.41205 9.47362 31.1162 6.35119 16.2437 -14.7539 +7557 6 47.0978 34.3186 24.1743 26.4285 -20.6373 22.1669 +7558 4 47.9222 34.8155 23.9694 -26.3889 2.76484 -4.38573 +7559 4 46.3048 34.7125 23.8251 -6.69439 19.4391 -11.1209 +7560 6 41.2781 35.6191 9.5379 -9.82526 -0.200667 -5.59214 +7561 4 40.3156 35.6289 9.77314 20.3165 9.2235 -0.933793 +7562 4 41.677 36.5159 9.62264 -17.3348 -12.0484 0.717846 +7563 6 20.4662 31.4486 3.15039 -21.7086 3.64016 -5.07598 +7564 4 21.0332 31.2208 3.90109 -5.23001 0.711793 3.99895 +7565 4 19.5233 31.6154 3.43158 26.7394 -6.53789 -0.258783 +7566 6 33.2215 17.9623 24.8097 -0.453891 -1.34226 7.30289 +7567 4 34.1788 17.9667 25.0617 -18.0356 9.24084 -3.8919 +7568 4 32.8105 18.8566 24.8334 12.2893 -13.6267 3.75162 +7569 6 40.152 39.887 35.7648 -20.6867 7.32712 26.7748 +7570 4 39.5869 39.7633 34.9934 2.3303 1.35559 2.0998 +7571 4 39.5428 40.1203 36.5292 18.9615 -7.74514 -25.9591 +7572 6 4.86846 34.7127 16.4904 2.99496 1.45153 -7.51648 +7573 4 4.94748 35.6438 16.2302 0.473437 -5.16658 -0.520329 +7574 4 5.67201 34.2663 16.1683 2.12015 0.152524 1.06444 +7575 6 19.1332 11.0374 26.5471 0.604362 14.7011 2.3555 +7576 4 19.0986 10.7741 25.6217 -2.73437 -5.06461 -1.05922 +7577 4 19.4813 10.3027 27.0576 -1.53582 -10.5153 -0.687646 +7578 6 54.0201 13.9196 34.7874 -7.69802 -2.07317 -2.05829 +7579 4 53.0764 13.9769 34.9536 -3.33021 -5.1824 4.14914 +7580 4 54.0417 14.262 33.8952 13.8623 5.56658 -9.2157 +7581 6 1.84699 20.6587 5.20972 14.9439 0.361847 -39.2318 +7582 4 1.3018 19.9191 4.88605 -0.816153 4.45331 11.6833 +7583 4 2.38828 20.8916 4.39492 -13.6739 -1.13034 29.3331 +7584 6 22.2428 0.0912174 14.2544 2.10511 -1.36215 24.2926 +7585 4 21.4939 0.626329 14.4934 -11.4394 6.88953 -7.77601 +7586 4 22.6568 41.86 15.1175 2.53583 -3.69112 -10.285 +7587 6 4.95629 7.04242 24.7427 6.31781 -9.23371 -7.19194 +7588 4 4.17782 7.32111 24.2434 0.969413 4.1364 5.47863 +7589 4 5.24611 6.21648 24.3187 1.32276 5.05146 9.71893 +7590 6 41.4805 20.8726 34.9438 -11.2314 22.7349 11.4525 +7591 4 42.1022 20.1554 34.9949 12.4759 -11.6791 0.0999164 +7592 4 41.5325 21.3468 35.8092 3.20944 -13.6901 -15.0483 +7593 6 28.2157 1.74547 31.725 -9.95228 -2.94536 5.02618 +7594 4 27.5723 1.08944 32.0352 4.54694 0.234407 -12.282 +7595 4 28.3302 2.26918 32.5198 6.68924 9.49254 2.75715 +7596 6 16.8899 27.3746 36.9858 -9.49677 -4.03922 3.2671 +7597 4 17.2157 28.1459 36.4964 2.86939 -7.49192 -2.31982 +7598 4 17.0938 26.5386 36.5152 1.89463 15.2676 -1.69393 +7599 6 26.8243 38.069 8.34482 13.7761 41.6132 3.1747 +7600 4 26.4823 38.3279 9.22598 3.84792 -18.6223 -11.4711 +7601 4 26.785 37.1424 8.19579 -7.88027 -37.9853 9.71444 +7602 6 26.6634 33.7911 23.2273 -21.2745 -8.43567 7.74896 +7603 4 27.1019 33.3181 22.5212 7.04537 -0.372104 -6.32159 +7604 4 27.3305 34.169 23.7872 14.5385 6.50935 5.10733 +7605 6 10.2166 27.1183 30.2276 16.2509 -17.1331 -9.46175 +7606 4 10.1765 28.0583 30.3796 2.29392 15.9864 2.71565 +7607 4 10.9387 26.9511 29.5696 -14.5483 8.58048 15.0042 +7608 6 47.87 12.5975 5.02268 -6.13754 10.9902 -1.31963 +7609 4 48.1357 13.4822 5.34438 -4.36861 -17.8106 0.719643 +7610 4 48.2725 11.9144 5.56853 6.38614 1.6905 7.47062 +7611 6 53.3393 24.5639 22.1523 -40.2275 -1.43509 1.91788 +7612 4 53.1884 24.513 23.11 6.12251 -0.709171 0.80005 +7613 4 54.2538 24.6676 21.944 28.1496 2.10984 1.66559 +7614 6 29.4072 10.7569 19.3822 52.4151 15.8336 -9.71081 +7615 4 29.248 9.98119 18.8618 -10.0643 -15.3346 -6.0739 +7616 4 28.6282 10.9567 19.8417 -45.3483 4.87471 22.9978 +7617 6 39.4757 14.9522 19.5461 30.0359 -1.30311 42.0602 +7618 4 40.386 15.231 19.9108 -38.5728 -7.77311 -23.4682 +7619 4 39.3498 15.357 18.6983 1.75067 15.7407 -16.9704 +7620 6 32.8823 15.9838 22.806 -0.988113 9.61369 -4.64335 +7621 4 32.9657 16.5376 23.5815 3.43203 16.8704 5.79609 +7622 4 32.7087 15.1359 23.1895 -5.55033 -22.0541 3.57771 +7623 6 30.5481 1.96835 21.5144 8.4955 -1.31523 7.25762 +7624 4 30.7645 2.06729 22.4547 -1.5525 1.72807 -3.05596 +7625 4 31.3563 1.607 21.1075 -12.3766 3.94884 0.453046 +7626 6 0.972615 11.9937 3.31932 2.75381 16.0475 9.69945 +7627 4 1.12058 12.9582 3.29011 -6.67466 -9.20629 -8.78254 +7628 4 1.16803 11.7633 4.23669 1.49118 -7.35844 2.879 +7629 6 32.1487 30.4035 20.7885 -10.2937 2.79415 -8.64413 +7630 4 32.9584 30.6778 20.3377 1.19491 2.22071 -1.75985 +7631 4 31.4018 30.7106 20.2304 12.8433 -5.61998 7.3235 +7632 6 5.36663 35.5196 9.0005 -13.7636 -10.8617 -1.51226 +7633 4 5.10558 35.6694 8.09522 3.88385 7.21083 -8.97177 +7634 4 4.84313 34.7327 9.21079 3.19207 0.561776 9.20467 +7635 6 49.9075 13.051 32.2032 24.7068 -1.78611 -22.7634 +7636 4 50.5917 12.8604 31.4934 -20.1594 10.2365 23.451 +7637 4 49.3072 12.3042 32.1357 -5.12737 -3.80929 6.93874 +7638 6 4.31321 24.0956 1.58545 -15.4175 -15.0012 -21.2972 +7639 4 3.62325 24.7374 1.73273 -2.73087 12.0747 8.21305 +7640 4 3.96758 23.5799 0.823479 15.3265 9.07188 13.8923 +7641 6 44.1581 38.1227 12.3545 -1.42535 -29.4608 0.820402 +7642 4 43.4877 37.5183 12.7749 7.78878 22.0847 -6.23147 +7643 4 43.9706 39.05 12.5061 -8.83193 8.8938 6.46859 +7644 6 44.688 17.3349 22.7943 52.857 -4.21013 7.29678 +7645 4 45.2391 18.0521 23.242 -20.6522 -19.8992 -14.1432 +7646 4 45.3699 16.6167 22.57 -26.4285 25.231 9.0384 +7647 6 20.3608 11.6914 19.667 7.58964 -15.1508 -20.1027 +7648 4 20.0231 12.466 20.0832 -9.22037 21.7722 17.9466 +7649 4 20.541 12.011 18.7627 0.78957 -9.8802 4.31695 +7650 6 4.45783 15.4051 36.2022 4.17523 -10.6616 -1.13379 +7651 4 5.07913 14.7124 35.8925 -4.22209 9.46347 0.0108161 +7652 4 3.57023 15.0045 36.1544 3.18966 5.51307 1.04981 +7653 6 44.8105 39.5245 30.1712 -12.2097 -12.5983 -29.4865 +7654 4 44.6649 39.2374 29.2388 12.2423 8.81859 19.2473 +7655 4 44.0848 39.0946 30.6384 -0.298867 5.38951 7.86823 +7656 6 30.0635 3.50956 11.3278 16.0802 -2.39158 -40.3094 +7657 4 30.5444 4.30508 11.007 -11.8296 -5.04519 20.5985 +7658 4 30.1379 2.92562 10.5291 -8.6007 1.99314 24.6663 +7659 6 25.6288 24.8657 16.1423 35.3146 -5.68436 -0.158812 +7660 4 26.5897 24.7732 15.9989 -9.69879 -4.30362 -13.2764 +7661 4 25.6615 25.1054 17.0605 -14.6317 7.6504 23.2411 +7662 6 36.8074 29.8609 20.6529 -16.3286 -4.81766 17.6852 +7663 4 35.9316 30.2459 20.3982 14.0867 -8.19012 9.60149 +7664 4 36.7164 29.3161 21.4988 -1.56746 21.2483 -31.978 +7665 6 52.2273 17.0565 38.3075 -18.6216 -30.1938 15.1193 +7666 4 51.4912 16.4635 38.6201 23.7372 14.7716 -7.00173 +7667 4 51.7959 17.5937 37.6524 -0.777677 7.661 -6.77585 +7668 6 3.82637 23.6296 29.8591 26.0466 24.015 14.1033 +7669 4 4.67122 23.3872 29.4436 -4.98409 -4.75234 -2.50433 +7670 4 4.14214 24.3103 30.5173 -20.0237 -17.5461 -14.7603 +7671 6 6.36694 19.9104 41.0994 -7.87156 6.69529 -0.551213 +7672 4 6.75531 19.2216 41.6418 3.91706 -4.8357 7.00798 +7673 4 6.43687 20.7189 41.61 0.371167 5.3541 9.12827 +7674 6 28.9069 38.9219 35.3342 18.1363 5.4885 19.4373 +7675 4 28.4975 38.2544 34.8057 -13.0204 -17.6003 -18.1497 +7676 4 29.7244 38.4883 35.6529 -6.84193 6.3312 -4.3373 +7677 6 1.06391 30.294 34.4744 17.4659 -4.25802 33.126 +7678 4 0.923806 29.8092 33.6831 -4.92213 -16.9626 -31.6436 +7679 4 0.43107 31.0027 34.4841 -13.3738 11.5818 -2.38269 +7680 6 26.4433 22.0338 20.438 10.4135 -19.5508 3.73058 +7681 4 27.3849 22.2767 20.3653 -17.5193 8.20183 -1.91668 +7682 4 25.8117 22.75 20.2981 5.30742 7.62512 -2.77887 +7683 6 3.9439 18.647 22.686 19.6053 -30.212 14.064 +7684 4 4.76982 18.631 23.2404 -22.0254 9.00566 -12.7221 +7685 4 3.71052 19.5535 22.5456 -1.30938 28.7031 -1.82281 +7686 6 6.87955 39.3273 26.9921 -1.67667 -12.9446 -11.9216 +7687 4 7.1836 39.9129 27.6984 -12.429 3.42242 7.34442 +7688 4 5.90054 39.2886 26.9896 13.9064 15.8094 12.8698 +7689 6 43.976 41.7556 26.5281 4.8347 -4.89589 -5.39334 +7690 4 43.9038 0.242071 27.3891 4.48323 5.1383 20.2804 +7691 4 43.1144 41.9148 26.1591 -17.5097 2.26447 -13.804 +7692 6 31.7137 29.57 16.9845 -29.8695 1.84649 5.70955 +7693 4 31.0051 28.8814 16.8861 15.511 13.0746 -1.88966 +7694 4 31.2475 30.3377 17.3963 12.872 -19.7765 -2.8161 +7695 6 46.2467 10.9544 15.5549 14.6537 -15.0388 13.4913 +7696 4 45.2992 10.7621 15.4719 2.35584 -6.3837 2.44855 +7697 4 46.7422 10.1008 15.6673 -18.7057 18.8904 -8.1417 +7698 6 36.5806 15.025 25.8165 21.8026 1.76557 9.13915 +7699 4 37.3648 15.4873 26.2149 -21.7037 -15.0217 -10.3096 +7700 4 36.1201 14.6319 26.5704 -2.31195 -1.95921 2.19148 +7701 6 47.2758 22.6707 6.12549 -20.393 21.5378 -17.5673 +7702 4 46.5536 23.2672 5.80637 16.9751 -15.6011 5.88158 +7703 4 47.0174 22.4855 7.02503 2.56882 -3.04752 8.65489 +7704 6 27.5281 39.6653 17.8063 9.11062 13.5998 -14.667 +7705 4 26.6008 39.6971 17.5421 -9.18871 -3.65478 0.40423 +7706 4 27.5952 39.1072 18.5692 -4.91094 -8.97362 13.813 +7707 6 14.0432 27.9674 36.8911 6.42031 -13.692 3.20322 +7708 4 13.4093 27.2386 36.6831 22.3711 16.0651 -1.21324 +7709 4 14.9745 27.6178 36.9209 -23.5128 3.35359 -2.56993 +7710 6 33.7582 13.0225 13.8549 2.82411 10.3644 -10.1378 +7711 4 34.6192 13.1187 13.3682 -26.1927 -14.0119 11.7219 +7712 4 33.447 12.1034 13.9061 16.5995 3.21583 -3.74575 +7713 6 3.39066 17.4794 1.96807 -11.027 -24.2448 -29.9928 +7714 4 3.01559 16.7425 1.36999 17.4474 35.7284 24.3857 +7715 4 3.43148 18.2603 1.39088 -0.910914 -5.0095 5.82543 +7716 6 27.5636 2.76805 36.4448 23.3016 6.40537 7.49337 +7717 4 28.0874 2.94382 35.6362 -14.0128 -4.70143 5.95918 +7718 4 26.7201 2.39292 36.1778 -1.1877 -0.145823 -5.22631 +7719 6 21.3174 1.20043 18.721 3.60184 -34.5623 26.1973 +7720 4 20.9731 2.06802 18.64 -8.90193 33.3239 -10.7294 +7721 4 20.989 0.903829 19.6038 6.52339 -1.5964 -17.0558 +7722 6 11.8953 16.678 29.2972 -24.0209 -12.1876 15.7906 +7723 4 10.9907 16.5502 28.9196 20.2967 4.53139 4.03679 +7724 4 11.83 16.2797 30.2084 5.50538 14.3948 -24.2902 +7725 6 15.9723 29.4609 29.6333 0.682268 26.1612 18.9471 +7726 4 16.8848 29.3174 29.3467 -1.47573 8.2327 2.84191 +7727 4 15.9822 30.2485 30.2615 3.64459 -27.0302 -18.4378 +7728 6 42.9269 7.03734 4.5197 11.663 -6.03152 6.53833 +7729 4 43.4231 7.50219 3.8104 -1.91258 -11.2042 14.7177 +7730 4 43.564 6.5391 5.10838 -14.9069 13.4822 -19.2581 +7731 6 46.4099 26.3175 18.5001 -14.65 2.77244 -10.2078 +7732 4 46.6739 27.1133 19.0164 -10.4759 -17.1195 -12.5948 +7733 4 45.7242 26.5969 17.8403 16.3643 -1.95791 15.5671 +7734 6 26.8576 31.9381 30.1176 11.4414 -26.9795 -35.8502 +7735 4 27.1259 30.9869 29.8859 -9.79711 36.6724 15.314 +7736 4 26.5998 32.3006 29.2227 5.46388 -10.7605 29.9307 +7737 6 19.4818 37.6192 31.2596 -32.5143 -22.3469 33.0613 +7738 4 19.0962 36.8501 30.8088 8.72557 8.52431 -5.84089 +7739 4 19.0944 37.5229 32.1795 16.9146 13.3756 -22.466 +7740 6 52.3665 32.7318 12.7942 -5.34222 7.33615 -3.08781 +7741 4 51.884 32.8768 11.9489 17.9119 0.95058 7.1847 +7742 4 53.27 33.1068 12.8183 -18.0778 -3.45769 -11.3622 +7743 6 6.73992 9.26339 24.0285 -18.4022 -33.2824 -0.456279 +7744 4 6.43016 9.52976 23.1488 2.39009 0.543925 -1.37305 +7745 4 6.14044 8.50785 24.2751 15.0572 15.2043 -3.93749 +7746 6 39.7373 39.5658 25.499 -11.0807 -5.52867 0.517577 +7747 4 39.7453 38.628 25.2585 2.77876 5.57729 -0.31401 +7748 4 38.826 39.699 25.8216 4.65786 0.889055 -1.26295 +7749 6 24.0734 14.0105 21.1438 13.9648 5.3121 -25.5312 +7750 4 23.6065 13.6215 21.8839 -3.42696 -11.6299 6.48748 +7751 4 24.3304 13.3134 20.491 -9.48085 14.6929 20.6508 +7752 6 5.1987 41.7736 24.8713 10.0047 -19.0707 10.1325 +7753 4 6.05769 0.0475547 25.2635 0.547146 -1.74599 -5.91735 +7754 4 4.86042 0.69526 24.5593 -4.41349 12.4443 -5.8689 +7755 6 42.3687 20.86 21.2777 19.2234 -22.1312 -1.40502 +7756 4 42.3783 20.5581 22.1846 0.624409 -1.73106 8.2154 +7757 4 41.7113 21.532 21.2665 -20.5735 20.428 -5.9858 +7758 6 48.2425 15.3687 33.5924 -0.241089 -2.38933 -5.28694 +7759 4 48.6415 14.7162 33.0072 6.18243 -4.87195 3.86709 +7760 4 47.6596 15.8553 33.0028 -7.11438 7.34599 -0.780278 +7761 6 46.0202 38.2953 16.5865 15.7829 17.4793 7.01852 +7762 4 46.7193 37.7552 17.0318 -13.8218 15.7663 -8.05182 +7763 4 46.1673 39.253 16.8241 -2.73609 -24.364 -6.22008 +7764 6 4.62701 28.4898 21.3631 -35.4199 -38.8764 -1.71187 +7765 4 5.05003 28.7578 22.1614 14.3175 13.903 20.3467 +7766 4 4.23296 27.6059 21.6238 11.0236 23.568 -16.8729 +7767 6 20.5692 15.1618 18.3974 -2.72234 -3.16682 18.7699 +7768 4 20.0205 15.9086 18.1633 -0.374776 9.93651 -8.10169 +7769 4 20.1114 14.8073 19.1799 7.71486 -3.14336 -3.02048 +7770 6 16.2446 13.6415 17.4737 -35.4034 4.06645 -23.9936 +7771 4 16.1835 14.6144 17.5029 6.20848 -12.1 -0.082548 +7772 4 15.5556 13.4035 16.7727 24.4056 2.85778 27.0666 +7773 6 52.5084 30.9566 18.1567 -0.97573 -12.5044 17.346 +7774 4 52.0533 31.4717 17.4985 -6.50351 10.4198 -16.9401 +7775 4 51.7821 30.6074 18.6971 11.4062 2.54252 -4.46582 +7776 6 24.418 1.73203 15.7939 2.07222 -10.1482 7.47229 +7777 4 24.2447 1.14878 16.5739 0.390494 16.7143 -9.44633 +7778 4 24.1366 2.64887 15.952 -0.929678 -6.23215 5.34629 +7779 6 23.8719 5.08832 31.0744 22.7283 -21.9769 -16.2257 +7780 4 23.8146 5.92648 31.5054 -7.3092 22.9653 9.22328 +7781 4 24.8319 4.92382 30.9303 -16.6577 0.531409 1.66203 +7782 6 29.6615 30.9343 0.410524 16.5859 -5.2272 -6.83283 +7783 4 30.4171 30.5602 -0.0763344 -8.98044 0.909776 12.9407 +7784 4 29.1293 31.2514 41.5907 -13.3941 8.54792 -1.14443 +7785 6 32.8591 37.9003 22.5268 -10.9299 -3.56267 -2.34485 +7786 4 33.7082 38.1164 22.1304 5.81458 1.66065 7.83892 +7787 4 32.835 38.1832 23.4516 6.53001 6.08896 0.386172 +7788 6 16.4762 17.3653 33.758 -11.7596 5.685 -6.41316 +7789 4 15.9639 18.0545 33.2621 15.6067 -10.6469 10.7903 +7790 4 17.1589 17.009 33.1621 -6.01342 7.59956 -1.04496 +7791 6 9.22918 13.3839 27.5418 -13.213 -9.30661 16.5651 +7792 4 8.30942 13.5198 27.2923 -4.71042 4.84624 -13.6557 +7793 4 9.0972 13.1179 28.4658 14.0632 -0.809421 3.61995 +7794 6 43.4685 7.73978 17.2176 -8.6426 5.21856 8.44668 +7795 4 43.4054 7.77113 18.1985 3.14312 -1.73226 -22.4674 +7796 4 44.4071 7.82788 17.0033 -0.931382 -0.0897333 1.197 +7797 6 22.3132 24.3412 23.1703 -9.75348 13.1727 -0.0757149 +7798 4 22.7871 23.5122 23.2675 1.8966 -9.89464 -1.11237 +7799 4 21.5045 24.1854 22.6454 4.5924 -1.52242 4.18414 +7800 6 26.0037 32.9236 32.716 -4.33416 -0.788049 -7.61174 +7801 4 26.2455 32.6516 31.8136 -0.0498336 0.850388 -0.133699 +7802 4 25.1949 32.4304 32.9126 -0.360701 -0.787143 2.76329 +7803 6 16.9426 19.041 7.45715 -3.10994 24.472 -2.41526 +7804 4 16.308 19.3093 8.14456 3.13816 -6.91205 -2.30089 +7805 4 17.0114 19.8381 6.87129 1.57938 -24.3813 10.2947 +7806 6 48.1131 14.4569 27.5699 7.08917 8.35207 6.49885 +7807 4 48.0603 15.1245 26.8691 -1.5138 -4.18476 1.16992 +7808 4 48.1537 14.9494 28.4126 -1.96213 -3.76556 -9.73571 +7809 6 52.3834 41.7541 11.1123 -0.447482 12.3 22.2377 +7810 4 52.3153 0.228199 10.2442 -0.817032 7.00513 -16.5207 +7811 4 52.6623 0.571857 11.7011 -4.41087 -5.87968 -8.23494 +7812 6 36.3325 6.93202 12.7048 -8.66608 5.7588 -1.53482 +7813 4 36.3873 7.88419 12.9074 5.41886 -9.49824 0.0534512 +7814 4 37.2464 6.6206 12.6662 3.93968 -0.5832 -0.272047 +7815 6 8.24609 20.3242 16.6676 2.28714 -8.73249 -3.11806 +7816 4 7.99607 19.3797 16.5602 0.915774 9.85224 4.30221 +7817 4 9.21956 20.3717 16.6442 -3.81833 -2.78155 -1.09608 +7818 6 28.8059 40.3215 12.8316 -6.32157 -2.99739 9.80695 +7819 4 29.5356 40.2333 12.2314 15.0973 -2.52646 -11.1155 +7820 4 28.4555 39.4209 12.8947 -4.4969 5.39171 3.74805 +7821 6 18.1648 11.8204 16.9538 6.42365 10.4423 10.6103 +7822 4 17.6537 12.6149 17.1793 -7.21931 -10.1359 -1.31065 +7823 4 19.063 12.1656 16.925 9.05203 -3.86377 -1.18548 +7824 6 30.8803 17.4233 21.4874 -38.9186 -21.5127 -11.6054 +7825 4 30.1793 16.7188 21.4067 15.4039 25.3522 4.50617 +7826 4 31.5864 16.9116 21.8642 20.5617 -1.86838 10.7411 +7827 6 34.8073 19.4112 37.959 10.4013 19.2527 -16.7989 +7828 4 34.9062 20.1671 37.3279 -0.177011 -16.5385 16.965 +7829 4 34.2544 18.768 37.5084 -3.31564 -7.45818 -3.12702 +7830 6 35.8251 16.8879 29.2053 19.9429 8.12055 25.1888 +7831 4 36.604 16.4922 29.6427 -6.21008 5.15879 -2.88988 +7832 4 35.5164 16.1914 28.6524 -12.7517 -21.289 -18.0185 +7833 6 3.03682 32.2806 6.33235 -9.22618 28.6071 10.2197 +7834 4 2.10307 32.1357 6.11945 6.4331 -12.4482 -1.5948 +7835 4 3.56193 31.5065 6.1559 2.8275 -21.5224 -7.32445 +7836 6 26.8 41.6522 10.1614 16.4152 -10.6242 6.62789 +7837 4 27.6763 41.4103 9.75871 -19.2491 6.11251 13.5217 +7838 4 26.9685 0.0827479 11.0562 4.26354 0.263175 -7.76775 +7839 6 52.2755 24.564 24.8743 -17.4742 4.09161 11.4913 +7840 4 51.3068 24.6875 24.9545 12.6777 -6.48001 -7.54331 +7841 4 52.5704 24.9086 25.7267 7.88636 1.59704 3.61539 +7842 6 22.6859 22.6471 33.5865 3.00815 -0.389016 -3.70522 +7843 4 23.2377 23.2516 34.129 -18.2936 -9.34398 -1.8364 +7844 4 21.8798 22.3666 34.0572 9.18357 8.33181 5.74035 +7845 6 10.6559 14.2334 33.0439 8.40108 -6.88321 -2.71679 +7846 4 10.5166 14.9368 32.4181 8.42324 10.9453 -12.1325 +7847 4 9.76709 14.0756 33.3137 -17.8131 -11.8211 11.2552 +7848 6 21.913 10.8504 11.5417 10.0273 5.1408 -10.1307 +7849 4 22.8643 10.6911 11.6864 -4.5907 0.219491 7.97275 +7850 4 21.4519 10.7503 12.3817 3.5408 -3.26695 13.1151 +7851 6 38.3604 6.02409 25.8423 -7.72295 28.2176 13.9057 +7852 4 38.0159 6.28095 26.7202 2.23326 -16.155 -4.56644 +7853 4 38.4362 6.90267 25.4438 5.48615 -7.56939 -11.5178 +7854 6 30.9465 26.6393 38.5732 9.04128 -30.5088 -25.1958 +7855 4 30.9128 26.4505 39.498 -1.67119 3.99535 28.8865 +7856 4 31.0441 25.726 38.2186 -4.36445 16.9712 0.749916 +7857 6 30.1667 14.6301 35.4838 10.1392 5.1159 -4.4805 +7858 4 30.5216 15.3681 34.9096 -25.1579 -14.4294 10.0398 +7859 4 29.1929 14.5877 35.5299 11.6839 11.6021 -8.75286 +7860 6 12.5351 37.2243 16.9695 -17.9994 -5.54058 0.759354 +7861 4 12.9667 37.9067 17.4519 9.84296 27.0859 15.3185 +7862 4 13.2146 36.5653 16.9126 10.1753 -19.489 -6.1469 +7863 6 27.4306 21.5582 37.7184 0.323044 -0.91237 -2.80926 +7864 4 26.8919 21.7087 36.9418 -1.95891 -4.49412 -14.6911 +7865 4 26.9535 22.0297 38.3943 0.198826 4.23191 11.3586 +7866 6 29.6082 18.3788 12.6829 -3.7237 -11.7076 25.6006 +7867 4 29.4829 18.1024 13.618 2.9495 3.49705 -16.1413 +7868 4 28.7034 18.5321 12.3984 -4.77545 3.00323 -3.28229 +7869 6 2.3585 15.6468 0.175999 -8.20612 37.5639 57.3692 +7870 4 1.52386 15.5898 41.6501 -20.1916 -9.73007 -21.8008 +7871 4 3.00191 15.1099 41.6903 28.5072 -35.3577 -30.6151 +7872 6 17.8194 25.7234 4.22068 -18.7286 -4.35761 2.03057 +7873 4 16.8619 25.5897 3.93795 36.6055 5.10926 -2.3659 +7874 4 18.4291 25.8425 3.4621 -13.2431 -0.0346718 7.72723 +7875 6 41.7912 11.1794 20.2704 -4.7703 -4.22644 -3.97484 +7876 4 42.5222 11.2179 19.6258 -6.77094 -1.14571 2.2342 +7877 4 40.9861 11.4636 19.8126 1.73275 2.14556 -1.92771 +7878 6 38.0378 18.3863 24.0278 -3.74133 -10.331 -0.132081 +7879 4 38.4309 19.0888 24.5482 3.22643 8.24914 5.57345 +7880 4 37.9308 18.7305 23.1431 0.767244 4.53126 -6.25669 +7881 6 4.13298 13.9173 33.7521 30.6843 -35.3272 -10.2657 +7882 4 3.2388 13.7394 34.0326 -6.45696 -6.01886 0.999898 +7883 4 4.62487 13.0231 33.6052 -30.6419 39.0128 7.66426 +7884 6 19.1936 19.1847 26.5022 -1.72621 -3.50471 2.07629 +7885 4 19.5259 20.0399 26.2155 5.41694 7.89262 1.74938 +7886 4 18.9505 18.7515 25.6854 -0.500338 -7.01675 -4.74744 +7887 6 22.475 26.1945 25.3345 -21.4458 -23.9003 -3.16659 +7888 4 22.3709 25.4906 24.6814 -7.32491 -4.57374 0.352876 +7889 4 23.3013 26.5414 25.0733 33.537 19.6696 -4.44151 +7890 6 48.8098 32.073 32.5556 -12.1052 4.48194 -0.190297 +7891 4 48.9381 31.1381 32.4233 -5.03309 -16.3747 0.495313 +7892 4 49.6354 32.4434 32.2762 12.9514 12.9364 -2.07298 +7893 6 25.2177 18.014 27.013 4.13139 4.11129 3.02633 +7894 4 24.4991 17.5573 27.49 6.6231 -0.568789 -7.074 +7895 4 25.6482 17.4406 26.3525 -8.92874 -1.57445 7.95973 +7896 6 1.76475 41.5608 24.9549 2.89162 -9.06076 -21.1384 +7897 4 1.88611 40.794 24.3317 -1.07403 19.5272 24.3581 +7898 4 1.30092 0.287142 24.3881 5.67761 -7.93757 11.1942 +7899 6 18.6633 11.7702 10.8608 -14.1102 -15.1967 11.3789 +7900 4 19.5021 11.9001 10.4051 -2.67857 -1.17934 -0.0567829 +7901 4 18.6465 10.841 11.1975 0.382459 20.6246 -9.54243 +7902 6 45.6242 16.5573 4.85031 17.0541 -2.39304 -3.72853 +7903 4 46.5701 16.2411 4.85652 -23.9929 13.0597 -1.64852 +7904 4 45.6057 17.5078 4.58964 5.38323 -15.7737 4.77093 +7905 6 40.6798 36.3894 24.0177 5.99482 15.2006 -18.5281 +7906 4 40.7505 36.8152 23.1136 -3.68852 -16.1642 25.9152 +7907 4 40.7388 35.4259 23.9735 0.360603 0.79119 -4.57544 +7908 6 32.2161 36.322 4.9431 5.19197 18.2152 11.0878 +7909 4 31.5074 36.1415 4.30154 10.9387 -10.0795 -6.57323 +7910 4 33.0257 35.7839 4.88769 -13.0089 -6.05715 -7.93038 +7911 6 1.60369 14.6754 10.8168 -10.3056 7.30247 33.6992 +7912 4 2.33423 15.3134 10.9307 -7.1595 -6.86026 -1.25923 +7913 4 1.1476 14.6845 11.711 13.0511 -0.847163 -26.6328 +7914 6 35.0153 14.2871 28.0739 18.7596 2.69464 30.5166 +7915 4 34.8734 14.0618 29.0187 14.279 3.49385 -12.2543 +7916 4 34.1456 14.1907 27.7398 -26.4062 -1.19123 -20.5956 +7917 6 54.7157 6.11907 21.8609 -12.1949 -7.16094 1.89291 +7918 4 53.7846 6.03827 22.1577 10.7478 1.95047 -3.13077 +7919 4 0.0370646 6.90146 22.3147 2.89466 7.98076 3.79048 +7920 6 31.7642 16.9274 27.3665 -7.54316 -5.52924 6.90942 +7921 4 30.8348 17.1206 27.2023 -9.34166 0.83246 -0.0222557 +7922 4 32.1928 17.2544 26.5838 13.9998 7.82105 -16.2222 +7923 6 14.4504 28.0052 11.1087 -4.71237 -14.6735 4.6077 +7924 4 14.1081 28.8557 11.3451 -9.65694 14.7183 8.34222 +7925 4 14.826 28.1745 10.2406 5.25389 -7.26775 -5.19981 +7926 6 35.6627 19.4906 18.309 1.38743 3.66357 1.00844 +7927 4 36.0608 19.4502 19.1905 -8.3289 1.62604 -1.04031 +7928 4 34.971 18.8114 18.299 7.41978 2.58016 -0.85803 +7929 6 0.908295 12.7232 15.4509 -10.2874 -45.1283 5.64528 +7930 4 0.635795 11.7526 15.3361 10.0925 35.0181 2.47128 +7931 4 1.39513 12.719 16.2997 -3.76012 1.73199 -7.91518 +7932 6 52.7239 14.8052 20.9911 -10.1838 -50.8962 13.8805 +7933 4 52.1355 13.9729 20.9263 20.4043 37.1153 -0.0771148 +7934 4 52.3678 15.481 20.4204 -9.75671 2.85516 -9.21068 +7935 6 7.50014 6.78453 13.6112 45.6118 -3.77462 -0.237279 +7936 4 7.66407 7.72531 13.7166 -11.095 5.64184 -2.33744 +7937 4 8.44113 6.46934 13.5548 -33.3093 -4.56257 -1.46213 +7938 6 12.8693 29.1327 30.951 -35.1999 43.7452 -37.9705 +7939 4 12.911 28.5157 30.2274 6.73286 -14.9776 0.757022 +7940 4 13.2432 28.8129 31.7306 26.8069 -31.1286 39.1504 +7941 6 8.91269 29.9946 35.6682 4.82638 -20.5676 13.9142 +7942 4 9.08199 29.9869 36.6487 -3.4848 12.9743 -23.6701 +7943 4 8.85763 30.8835 35.2999 2.4913 8.97671 5.8399 +7944 6 29.2501 7.21193 5.56384 -35.3124 23.3999 -5.45769 +7945 4 29.8929 6.567 5.7677 24.3163 -25.3556 4.38867 +7946 4 28.4878 7.00912 6.14468 16.2636 8.35776 -7.44031 +7947 6 25.8882 9.2493 3.85609 -10.1418 -10.3657 2.14015 +7948 4 26.6938 8.77544 3.58522 -5.62061 -1.52714 -0.987441 +7949 4 25.143 8.71761 3.5088 14.4855 4.13341 2.07026 +7950 6 46.1828 19.5303 23.8452 27.5142 -8.79556 18.2338 +7951 4 47.0303 19.3932 24.4147 -29.6641 11.3761 -34.952 +7952 4 46.4302 19.9015 22.9687 10.0609 -5.49214 13.8961 +7953 6 18.6 35.3226 28.7813 33.9262 -21.2248 5.29661 +7954 4 18.5078 36.1255 28.2543 2.15121 5.76995 -5.3877 +7955 4 19.5645 35.0126 28.755 -37.0827 17.274 -2.06568 +7956 6 28.0068 22.625 32.1882 17.1638 -9.71048 -11.652 +7957 4 28.1161 23.0799 31.3381 -0.933036 0.686599 6.01892 +7958 4 27.1717 22.9224 32.5558 0.319614 0.839726 2.26602 +7959 6 25.9992 18.4251 22.6716 -8.51512 -6.6596 14.3523 +7960 4 26.8098 18.8237 22.3895 20.3106 6.57833 -11.9809 +7961 4 25.8253 18.8771 23.5162 -1.041 -7.57666 -6.79729 +7962 6 31.1689 23.0872 29.1831 -2.26749 -18.4759 6.78914 +7963 4 31.118 22.1592 28.8841 -5.05583 5.59361 3.05947 +7964 4 31.7418 23.5345 28.5581 5.1573 7.79625 -4.49352 +7965 6 36.6391 4.9259 0.480345 37.9344 10.2065 -26.5572 +7966 4 36.638 5.82198 0.886244 0.658013 -14.6584 -5.92388 +7967 4 37.39 4.95173 41.699 -35.1456 1.42767 30.4358 +7968 6 36.484 21.0145 10.0529 -6.00883 6.48187 8.17175 +7969 4 36.4042 20.1763 9.58301 3.63574 2.58382 -3.15576 +7970 4 35.8773 20.9259 10.8015 2.14778 4.06152 -0.936887 +7971 6 50.5993 25.1947 18.3919 -28.2028 12.9956 8.35013 +7972 4 49.869 24.7394 17.9262 9.19638 1.46827 3.55355 +7973 4 51.4482 24.8993 18.0848 11.0575 -8.08323 -5.33222 +7974 6 50.1824 39.6576 12.4356 -22.7811 -7.9912 15.1349 +7975 4 49.7705 38.7879 12.6194 4.75387 11.043 -2.88475 +7976 4 51.0686 39.4751 12.1603 15.8621 -1.53988 -6.37666 +7977 6 30.5412 12.4178 4.80566 -15.3128 -2.78075 25.3711 +7978 4 30.0752 11.5776 5.01806 10.6669 11.6172 -5.90727 +7979 4 31.021 12.2424 4.01172 11.531 -8.83371 -18.4272 +7980 6 28.9525 15.4713 21.8679 -2.36978 -36.4192 26.6063 +7981 4 29.1677 14.6271 22.3934 -7.66269 33.2693 -19.6276 +7982 4 28.1632 15.8063 22.3348 7.54721 -2.84859 -11.2752 +7983 6 14.0684 9.5583 16.997 2.7235 -6.59901 -0.744295 +7984 4 14.8185 8.94582 17.0717 -0.0957791 5.7783 -3.11218 +7985 4 14.4323 10.4488 16.9992 1.00571 2.57913 -1.39277 +7986 6 4.48903 30.1743 11.858 18.777 -10.7052 13.2768 +7987 4 4.86699 29.7697 12.6847 -17.3276 7.96894 -17.1216 +7988 4 3.53137 30.2861 11.9207 -0.113543 -0.314347 4.01346 +7989 6 40.8874 8.0652 23.6541 0.993335 -18.0149 -24.6412 +7990 4 41.0014 8.23968 22.6934 -0.45004 7.6784 15.1082 +7991 4 40.7726 7.0925 23.6399 1.20374 9.92563 8.58777 +7992 6 53.7462 35.0557 16.7061 9.98011 -4.48961 -22.2856 +7993 4 53.4827 35.8182 17.2307 0.000554802 6.10184 -1.96461 +7994 4 54.0786 35.3449 15.8213 -7.68991 -0.599931 23.4559 +7995 6 53.7073 10.1889 20.3718 -10.7517 16.2467 -19.4493 +7996 4 53.8408 10.0262 19.4272 8.41512 -10.415 5.03553 +7997 4 53.1338 10.9644 20.2967 0.731263 1.06205 11.7435 +7998 6 4.58979 27.075 7.78807 17.6653 -15.6715 -1.75621 +7999 4 5.19096 26.32 7.80399 16.3727 7.79792 -3.24405 +8000 4 3.78382 26.6199 7.94519 -28.415 1.42755 3.38346 +8001 6 50.5066 22.5306 22.1436 -1.2339 18.6921 5.41009 +8002 4 50.2802 23.3104 22.6632 -2.8343 -11.09 7.6214 +8003 4 50.7991 22.9414 21.3369 4.56213 -7.53044 -15.8119 +8004 6 7.04346 27.196 21.628 9.41144 -9.96736 11.8657 +8005 4 6.8407 26.6883 22.4668 -8.25713 16.2835 -27.3312 +8006 4 6.26031 27.4748 21.116 4.26862 -9.43237 15.0117 +8007 6 23.8265 35.0499 16.5937 18.3012 9.13896 26.4348 +8008 4 24.7235 34.8381 16.9269 -14.9485 7.62278 -2.13189 +8009 4 23.7604 34.5968 15.7714 -3.77201 -11.7597 -22.7393 +8010 6 5.98953 23.8983 3.91761 -44.4181 -14.5448 -1.98234 +8011 4 5.398 23.9519 3.1318 15.794 0.401012 8.45254 +8012 4 5.35617 23.6012 4.61938 19.6174 4.72778 -5.04958 +8013 6 38.7401 25.0729 19.1247 8.8169 4.91643 10.7802 +8014 4 38.7862 24.2921 18.5681 -1.99613 -8.272 -9.94687 +8015 4 39.0639 24.8191 20.0061 -2.94522 4.87881 -4.09917 +8016 6 12.9717 18.2893 10.6182 7.92512 -8.05782 -7.58833 +8017 4 12.0999 18.3162 10.2013 -2.76008 2.25331 1.21984 +8018 4 12.8722 18.6085 11.5165 -3.68712 5.29275 10.5515 +8019 6 38.0382 41.2423 21.0873 4.88219 -19.6272 -0.152698 +8020 4 37.2014 40.7765 21.2484 2.63704 8.02432 -2.02816 +8021 4 37.8835 0.198079 20.7163 -11.2369 15.8096 -5.69312 +8022 6 6.98214 22.8682 17.8394 -5.75247 -17.9204 -1.57462 +8023 4 7.61723 23.542 17.6412 15.6839 20.0065 -5.16874 +8024 4 7.3587 22.0484 17.4826 -2.13646 0.815835 3.23256 +8025 6 24.1186 19.368 12.3177 21.0449 6.23804 -24.2445 +8026 4 23.9242 19.844 13.1293 -4.19124 -3.15082 3.8784 +8027 4 23.743 18.4928 12.3308 -10.9397 -14.908 7.07664 +8028 6 44.2213 28.4415 4.8153 2.12167 -7.44997 -5.8313 +8029 4 44.3009 28.0649 3.91739 -1.37383 9.18016 5.99771 +8030 4 44.2294 29.4128 4.74855 1.01191 -3.53144 -7.03239 +8031 6 23.3167 8.29314 21.4338 -0.329791 14.7993 14.6131 +8032 4 22.995 9.23581 21.5362 7.25813 -26.2111 -7.67418 +8033 4 23.1349 8.01865 20.5229 -2.36131 4.58949 1.23489 +8034 6 14.3464 2.19127 18.5365 1.00479 -5.05512 -1.33996 +8035 4 14.3534 1.26337 18.7781 -10.0191 -8.45544 9.17935 +8036 4 15.2531 2.29149 18.2562 13.6881 11.5937 -7.27189 +8037 6 28.0536 31.92 34.134 3.57463 -14.0429 -1.6048 +8038 4 28.4517 32.4188 34.8607 -2.66641 5.35559 -0.0232853 +8039 4 27.3246 32.4577 33.7701 8.655 -3.68096 2.2403 +8040 6 53.3502 24.7032 18.2649 -24.2711 -41.2818 -9.83264 +8041 4 53.5194 24.6019 17.3193 6.96991 8.47211 -0.102973 +8042 4 53.68 25.5059 18.6169 17.7955 37.5084 3.34479 +8043 6 36.8031 28.4187 22.9511 -10.1554 -0.61119 21.2214 +8044 4 36.5106 28.9054 23.7358 4.15696 8.73481 -5.19311 +8045 4 36.1845 27.6911 23.0035 -2.36033 -17.8474 -9.79811 +8046 6 21.8885 30.5877 27.4793 -3.11585 8.28062 7.57241 +8047 4 22.2621 31.0993 28.2061 -3.96796 1.5816 4.48491 +8048 4 22.5937 30.5949 26.8475 10.2249 -8.24374 -18.6607 +8049 6 10.2833 3.28406 27.2289 -24.5304 -2.91212 14.6365 +8050 4 10.0443 2.76427 28.0065 14.6588 -5.9106 -2.57837 +8051 4 9.44832 3.75002 27.1066 2.80489 10.142 -13.305 +8052 6 37.7147 24.9939 29.6988 5.24245 -12.5023 -10.1121 +8053 4 38.3581 24.5533 29.0689 -23.3017 1.4918 23.5498 +8054 4 37.1779 24.3214 30.1874 12.7329 5.56421 -12.5271 +8055 6 9.13611 24.4367 14.4784 20.7258 8.96054 28.4908 +8056 4 9.04651 24.998 13.735 -5.03994 20.1658 -22.0876 +8057 4 8.726 23.6299 14.2398 -14.2121 -32.2206 -7.12291 +8058 6 52.7755 31.4643 7.39569 14.5412 -1.52098 0.484013 +8059 4 52.3413 32.1584 6.88884 0.00633314 4.2069 -4.47258 +8060 4 52.0605 30.9716 7.79316 -9.34275 -9.05133 5.36325 +8061 6 21.3287 5.44475 36.4975 17.176 -11.9485 -14.2877 +8062 4 20.7483 5.50715 37.2619 4.90115 -8.53405 7.77147 +8063 4 21.912 4.64524 36.5597 -18.1029 20.6035 4.94996 +8064 6 25.1768 37.2214 4.32574 4.31983 -25.8241 -7.35849 +8065 4 25.4326 36.64 3.57657 -1.88178 18.0132 5.09494 +8066 4 24.8685 36.5657 4.9694 -1.32139 10.7309 7.78615 +8067 6 33.9928 17.4475 18.2473 -28.4515 -0.0793518 28.5349 +8068 4 34.2921 17.0113 19.1053 -15.0281 13.9289 -20.2703 +8069 4 33.1064 17.9171 18.4165 33.1367 -21.5966 1.81969 +8070 6 37.9532 37.4932 25.2939 -37.7872 -15.4269 -20.4394 +8071 4 36.979 37.7096 25.1406 34.3292 -3.43428 9.43604 +8072 4 38.1084 36.7677 24.6487 1.47089 11.2608 10.0337 +8073 6 5.08061 4.87523 15.8431 -4.86231 -7.56388 -2.23136 +8074 4 5.78156 4.1744 15.8759 -9.54967 26.0091 2.46095 +8075 4 5.43258 5.75 16.0822 6.78608 -13.538 3.56789 +8076 6 14.1628 7.20449 7.78038 25.2379 -5.46067 -13.6381 +8077 4 13.5115 7.54153 8.36471 -22.6877 11.2017 23.85 +8078 4 13.6914 6.99143 6.96374 5.13235 0.836748 0.117842 +8079 6 24.9714 10.8522 38.0874 21.7543 24.8019 24.8971 +8080 4 25.3733 11.7327 37.9223 -2.75098 -14.513 10.3213 +8081 4 24.5811 10.6456 37.27 -22.0988 -18.3607 -37.1034 +8082 6 35.6792 7.98105 22.8098 -5.63995 -0.874411 -1.68631 +8083 4 36.3111 8.66137 23.0699 5.30437 2.23481 0.770305 +8084 4 35.3824 8.20038 21.9134 0.62108 2.61089 2.3422 +8085 6 24.7967 29.145 22.4166 8.97915 1.26062 2.6062 +8086 4 24.9285 28.4017 23.0307 -7.24415 3.31799 -2.87627 +8087 4 23.8684 29.1691 22.1667 -6.93063 -5.53381 0.128782 +8088 6 38.5003 31.6402 38.4666 0.118802 17.9484 -3.06973 +8089 4 38.5639 32.3894 37.8454 -0.598215 -11.959 -0.514206 +8090 4 38.3632 32.08 39.3134 -2.43734 -3.45212 12.1107 +8091 6 7.2246 33.2558 15.4144 3.93224 14.6297 14.7993 +8092 4 8.10558 33.3578 15.8508 -19.4169 -6.69939 -13.0108 +8093 4 7.30076 32.5035 14.7978 2.24681 10.3389 8.67702 +8094 6 43.3411 23.605 1.45378 1.24542 -6.52262 6.11498 +8095 4 43.1714 24.3501 0.858367 5.1295 -5.17404 3.37123 +8096 4 44.2208 23.7695 1.84296 -12.8059 2.13297 -8.4534 +8097 6 3.53981 32.9157 14.8686 -7.67856 -8.73615 6.98201 +8098 4 3.60397 33.2061 13.9566 0.668747 6.43783 -7.96574 +8099 4 3.81902 33.649 15.4236 5.03764 7.23473 -0.501009 +8100 6 25.308 21.7722 8.24708 3.37146 -12.406 14.7751 +8101 4 26.0573 21.1741 8.36562 1.41198 8.84323 -6.65363 +8102 4 24.826 21.6647 9.09095 -1.64121 7.89428 -12.8382 +8103 6 43.814 15.3562 17.763 -19.8802 -3.64728 -7.58039 +8104 4 43.4756 15.1225 16.8733 5.20247 0.973102 4.81929 +8105 4 44.7686 15.2775 17.7045 7.07231 -2.77487 -5.74422 +8106 6 15.7867 16.2594 16.6597 40.7179 11.0003 30.8626 +8107 4 16.4245 16.8568 16.2414 -0.344326 0.180624 1.74019 +8108 4 15.1074 16.2177 16.037 -41.8412 -2.72902 -33.087 +8109 6 31.9018 12.864 11.5221 -0.527288 11.9796 -2.61342 +8110 4 32.4715 13.19 12.2739 -15.261 0.218931 -18.2329 +8111 4 31.4408 13.5947 11.0331 13.5047 -10.6099 18.0399 +8112 6 18.2179 5.3463 10.1762 9.71532 5.2148 -18.3501 +8113 4 17.8204 5.66693 9.33813 -2.6575 -7.74782 15.1878 +8114 4 17.5556 5.18411 10.851 -9.29453 0.73034 -3.17809 +8115 6 23.0812 39.0781 10.9303 2.37609 8.25457 -4.90642 +8116 4 24.0025 38.8104 10.892 -1.10831 -0.594451 2.83356 +8117 4 23.078 39.9337 10.4697 -7.78026 -4.85412 5.47405 +8118 6 46.8678 33.747 8.76655 -5.11485 44.7451 24.4631 +8119 4 46.406 34.5339 8.40734 -0.304999 -21.98 -10.152 +8120 4 47.1603 34.1422 9.62028 2.09293 -20.2864 -11.5212 +8121 6 31.2447 39.9321 20.2226 -0.330123 -0.585472 -4.98228 +8122 4 30.8504 39.3151 19.5884 6.05804 4.05585 3.92388 +8123 4 32.2053 39.9316 20.0453 -4.95864 -1.44581 -1.12159 +8124 6 15.9016 33.0949 19.7876 25.1907 -5.52815 -22.1207 +8125 4 16.0748 33.7133 19.0349 -1.92202 -14.988 11.1016 +8126 4 16.5267 32.3265 19.6592 -15.8695 19.8556 5.2806 +8127 6 32.5654 39.9188 2.66304 17.6014 -10.2623 -15.3377 +8128 4 33.3417 39.59 3.14903 -11.9816 5.68487 0.865723 +8129 4 31.9971 40.348 3.29791 -5.42947 4.08066 9.69521 +8130 6 50.71 12.2088 3.91621 6.45352 -28.1924 -19.9843 +8131 4 51.4315 12.4725 3.33505 0.00989865 5.72461 1.55844 +8132 4 50.5782 12.8645 4.57223 -0.528152 29.464 22.8196 +8133 6 44.6954 2.75762 12.1022 0.941183 0.541095 5.21442 +8134 4 45.0772 1.91827 11.8337 7.97486 -4.13832 -5.1586 +8135 4 44.7961 2.76556 13.0748 -3.12194 1.26681 -13.8655 +8136 6 11.5119 11.9446 31.6555 0.0165034 5.87533 16.9496 +8137 4 11.2786 12.7291 32.193 1.1093 -4.42098 -1.85793 +8138 4 11.5615 11.2089 32.2952 3.49417 6.36211 -10.0029 +8139 6 4.75553 10.0442 10.5026 -0.613356 7.28818 -1.41717 +8140 4 5.04922 10.2458 11.3982 -0.190174 3.033 -2.19553 +8141 4 4.45357 10.8768 10.0827 4.22944 -8.29703 6.91569 +8142 6 17.1004 25.0221 20.585 20.8628 27.7333 -27.8469 +8143 4 16.2314 24.7196 20.7848 -24.892 -11.5638 6.73224 +8144 4 16.9745 25.5771 19.7683 4.93088 -15.3222 19.1034 +8145 6 48.1032 4.75801 14.8026 37.7024 -16.8658 7.41777 +8146 4 47.1817 4.923 14.9438 -21.3904 13.2232 -6.86149 +8147 4 48.4894 5.33532 14.1187 -17.354 1.23192 4.40994 +8148 6 18.8584 3.1094 3.41532 -17.9645 -5.092 -5.76247 +8149 4 18.4858 2.24853 3.65522 2.22195 0.198645 3.24183 +8150 4 19.7914 2.99202 3.55078 21.8001 -2.9136 1.99579 +8151 6 35.4214 26.4496 29.0479 -25.0869 -13.2406 8.30382 +8152 4 35.4596 27.2122 28.4766 3.66886 10.9927 -9.48044 +8153 4 36.2884 26.0622 29.0901 17.6032 -4.12101 -3.28535 +8154 6 32.3918 31.2203 12.8386 46.3164 14.9485 -1.56764 +8155 4 31.5927 31.2548 13.3118 -34.7781 -0.694705 18.2501 +8156 4 32.2274 30.836 11.9945 -8.46486 -12.2685 -25.2096 +8157 6 32.9972 28.3347 37.5978 -19.2694 -14.478 20.0019 +8158 4 32.1604 27.8545 37.87 25.9433 12.8245 -4.2723 +8159 4 33.4478 28.5699 38.4425 -10.0504 -3.89776 -17.7975 +8160 6 45.4943 24.785 10.3174 -24.9891 51.3938 13.5053 +8161 4 44.9436 25.3819 9.72852 18.6998 -28.2383 15.0369 +8162 4 45.6946 23.9769 9.88803 3.95472 -26.3164 -24.236 +8163 6 14.7646 31.7016 3.17106 -12.494 -4.77828 16.8956 +8164 4 14.1278 32.382 2.84257 8.55448 -13.727 9.9815 +8165 4 14.4774 31.2925 4.03575 0.781246 20.1514 -26.73 +8166 6 31.932 7.70259 4.29822 28.2629 -13.9597 32.9447 +8167 4 31.5142 6.8338 4.23667 -1.26054 0.464616 -4.26218 +8168 4 31.5893 8.26695 3.64018 -18.9284 22.0156 -31.588 +8169 6 42.5661 17.3076 32.2072 4.58091 20.9841 -12.8778 +8170 4 41.6153 17.2751 32.1225 -13.9289 -9.63208 0.974916 +8171 4 42.7549 18.1312 31.7017 7.23855 -15.1499 9.29454 +8172 6 13.801 23.1802 23.5544 20.5107 -9.18639 9.43365 +8173 4 13.5559 23.799 24.2431 -7.02941 8.57916 4.58982 +8174 4 14.6139 22.757 23.9348 -15.8084 7.21572 -12.2969 +8175 6 10.7224 7.09218 3.96878 16.2046 -14.1912 -58.7694 +8176 4 10.4615 7.01435 4.86228 -13.7845 -9.22242 34.898 +8177 4 10.4899 6.25858 3.45399 4.94204 24.1379 24.5516 +8178 6 28.7975 8.66057 17.8838 -26.4281 5.00156 -27.4828 +8179 4 29.5466 8.31163 17.3909 5.91048 -3.96826 -5.96201 +8180 4 28.1517 8.96764 17.1731 20.0585 -9.38402 22.2692 +8181 6 19.4445 29.3512 26.6402 -27.7559 12.8002 37.2849 +8182 4 18.9931 29.7086 27.4672 16.1765 -10.1498 -30.4371 +8183 4 20.3292 29.7071 26.6996 8.86807 3.45557 2.67965 +8184 6 40.676 40.9989 14.5783 -1.81287 -10.2023 17.4849 +8185 4 40.8703 41.6798 13.9303 10.8761 5.87921 -5.34291 +8186 4 41.4788 40.6754 15.0317 -0.103076 9.61372 -9.63617 +8187 6 46.2568 14.0853 31.7234 10.6503 -1.46249 4.93376 +8188 4 46.4506 13.1375 31.7184 -3.79774 3.42444 -0.601084 +8189 4 45.5065 14.2191 31.1522 -8.96365 0.976246 -7.34606 +8190 6 36.7103 36.3065 8.39844 -19.1971 -27.2559 -17.1971 +8191 4 36.3822 37.2167 8.51449 20.2374 -9.10083 14.9839 +8192 4 37.462 36.0245 8.9597 -8.83948 23.9771 2.75809 +8193 6 30.7983 32.4219 38.0908 -28.9564 1.76229 18.7871 +8194 4 31.3387 31.9445 37.476 23.2205 -2.83162 -11.1976 +8195 4 31.2894 33.1287 38.5298 9.85106 -3.61838 -6.87003 +8196 6 47.9 8.84746 10.1809 13.9026 13.2481 4.99334 +8197 4 47.2314 9.07534 9.54683 -14.9306 19.0332 -8.73943 +8198 4 48.008 7.93273 10.003 10.2061 -26.7512 4.08493 +8199 6 24.4282 17.0027 30.9766 -8.14946 0.47403 -13.61 +8200 4 23.7021 16.9118 30.3187 14.132 0.581257 9.28124 +8201 4 24.0019 17.1514 31.8341 1.66288 -1.35228 -5.87998 +8202 6 40.5039 5.09263 4.48513 -8.56504 -6.5373 -32.2613 +8203 4 41.2755 5.64065 4.37578 16.2932 9.35997 9.97847 +8204 4 40.1843 5.0523 3.55179 -2.89742 -7.45623 19.6864 +8205 6 52.5794 28.086 6.91602 -27.2154 -20.1235 6.97783 +8206 4 52.4353 28.6007 6.11552 3.94928 -0.112987 0.705634 +8207 4 51.6969 27.6552 7.08025 27.1089 14.7333 -4.60736 +8208 6 36.0629 32.381 23.6142 9.17579 -16.9148 -2.4755 +8209 4 36.5407 32.2813 22.7776 -1.15674 3.38979 7.41153 +8210 4 35.7113 33.2654 23.6252 -9.15386 11.2493 0.0331211 +8211 6 23.6552 31.8756 22.7565 -25.0136 1.00336 21.6204 +8212 4 23.73 32.5959 22.1297 15.1034 -2.64982 -11.1407 +8213 4 24.3343 31.2055 22.6866 12.2933 -0.39941 -10.0267 +8214 6 0.736598 24.4641 41.7072 -6.94393 1.55048 -19.4095 +8215 4 1.23654 24.8288 40.9522 -3.95743 -2.80997 9.51773 +8216 4 54.8325 24.2702 41.3637 13.4109 4.08216 3.5339 +8217 6 15.9721 8.97822 19.8125 19.0517 -22.613 16.6544 +8218 4 15.5497 8.29105 19.3091 -4.28185 -9.24838 -10.3339 +8219 4 15.6128 9.78815 19.5092 -16.7051 35.4763 -13.493 +8220 6 33.1656 12.5735 20.0353 32.8597 -32.3881 -24.7893 +8221 4 32.9817 11.6196 19.8453 -6.04217 28.6875 8.28399 +8222 4 34.1172 12.6638 19.7368 -32.1809 10.6792 11.3696 +8223 6 7.04894 24.9401 26.3957 -12.3425 -2.00741 -5.21086 +8224 4 6.75821 24.2907 27.0478 8.01299 -1.99342 6.24335 +8225 4 7.89161 25.3154 26.6505 10.7219 -3.29246 12.7441 +8226 6 44.479 22.5508 36.9163 -6.8399 -5.44184 13.3083 +8227 4 43.5214 22.4098 37.071 12.5044 3.3732 -3.51472 +8228 4 44.595 22.7899 36.0028 -4.86816 3.42784 -13.6235 +8229 6 39.2745 23.7032 25.1197 -32.3737 -81.7274 9.17932 +8230 4 39.5886 24.5492 24.9992 24.471 68.8814 -13.2187 +8231 4 38.7456 23.4691 24.3377 5.22396 6.33701 6.85867 +8232 6 20.3646 2.19602 36.9892 -4.85825 6.83938 3.69158 +8233 4 20.3067 1.45038 37.5971 1.4243 -8.23943 -2.36696 +8234 4 20.3942 1.88275 36.0861 3.42557 -6.35335 -2.19064 +8235 6 22.8664 19.5513 3.67104 -13.2265 5.28042 31.2857 +8236 4 22.7633 19.8561 4.6286 7.01101 -9.22167 -32.7463 +8237 4 23.7764 19.7315 3.39612 4.00916 2.85623 5.02623 +8238 6 31.705 12.5768 34.6039 18.8969 7.7197 42.0834 +8239 4 31.1026 13.3107 34.9476 21.2302 -23.3848 -5.30166 +8240 4 32.3569 12.3026 35.3493 -33.8624 17.1964 -33.567 +8241 6 12.9851 10.2105 25.0956 -25.1193 26.0078 -38.429 +8242 4 13.6149 10.0452 25.7619 22.39 -15.9831 32.7066 +8243 4 12.4963 9.40655 24.9468 1.34194 -14.9569 1.62555 +8244 6 27.2621 0.584423 13.2176 -28.6404 -16.2485 2.71576 +8245 4 27.7069 41.6292 13.1518 2.13728 8.59646 -2.51953 +8246 4 26.2847 0.395264 13.1771 23.0038 6.72582 -0.601928 +8247 6 5.66006 24.9398 13.9833 -7.43295 9.91556 10.5591 +8248 4 4.70147 24.9177 13.9802 -4.26929 -7.73667 -8.07402 +8249 4 5.82197 25.381 14.8221 8.41297 -1.15026 -0.763214 +8250 6 22.9908 17.9523 0.521723 7.02411 -25.4698 12.909 +8251 4 22.4592 18.6506 0.142784 -9.22706 3.46645 -2.83539 +8252 4 22.3527 17.3052 0.930771 13.2695 22.3169 -13.3733 +8253 6 33.0935 25.4243 5.46557 -9.38497 -10.8046 -8.60877 +8254 4 33.4966 26.2756 5.44764 14.9521 17.8538 5.01915 +8255 4 32.9941 25.2035 4.5344 -2.6207 -6.96629 2.5324 +8256 6 8.53079 7.95552 17.4804 7.64086 6.41223 -26.4035 +8257 4 9.4001 8.35547 17.2638 -9.73917 -4.33322 7.64386 +8258 4 8.4487 7.94255 18.4286 4.30191 2.70426 16.6029 +8259 6 26.8371 0.685906 2.89773 -0.256761 31.01 4.86999 +8260 4 26.7806 0.433187 3.83156 0.637082 -2.67537 2.60738 +8261 4 26.6279 1.66343 2.89109 6.9325 -26.481 -2.08778 +8262 6 50.0417 34.7142 15.6334 -23.0288 8.72534 -30.9996 +8263 4 50.5531 35.2159 14.9759 6.02412 -4.51102 12.1494 +8264 4 49.1615 34.6714 15.1751 14.0914 -5.62478 19.352 +8265 6 46.2791 4.99946 11.1196 9.7179 12.4772 -7.72995 +8266 4 45.7827 4.25534 11.4529 -10.6417 -11.5364 6.26713 +8267 4 46.9456 4.6214 10.5389 1.00953 -4.68959 -1.2994 +8268 6 33.7936 38.6123 35.3918 15.2762 25.882 47.4359 +8269 4 34.0305 39.0866 36.2411 -6.18084 -28.1229 -24.2145 +8270 4 33.6134 39.3784 34.8506 -5.42867 -1.33428 -20.4371 +8271 6 30.8282 25.8371 41.2172 -7.09757 -19.9215 -22.3179 +8272 4 31.1427 24.9253 41.375 1.19635 8.28989 4.89631 +8273 4 31.1138 26.3841 0.0263053 10.2845 10.2166 22.0109 +8274 6 50.2275 0.982033 24.4751 51.8832 -7.79127 14.7425 +8275 4 49.5671 0.561213 23.9746 -37.5145 -10.5742 -20.1648 +8276 4 51.0349 0.46072 24.2534 -17.6876 18.8276 11.0022 +8277 6 31.2908 0.710797 19.047 -2.09434 13.573 -1.22083 +8278 4 30.4487 0.672221 18.611 -14.5784 9.11804 -11.7691 +8279 4 31.2841 41.7946 19.4765 8.98672 -35.4229 20.9418 +8280 6 39.0741 29.5515 19.1276 -25.3595 -21.9961 15.137 +8281 4 38.1807 29.4949 19.565 25.109 7.94863 -12.7917 +8282 4 39.4837 28.6866 19.3452 2.49072 15.8212 -6.56848 +8283 6 21.6546 17.5955 25.8962 -6.78298 15.7545 0.118362 +8284 4 22.0482 18.4938 26.0891 -15.3421 -24.4294 -5.96834 +8285 4 20.8112 17.7106 25.4012 18.8301 2.25602 6.45745 +8286 6 35.0761 28.7988 27.4227 3.11164 -5.22767 30.3338 +8287 4 35.4099 29.4705 28.0422 -1.31539 -7.25274 0.820077 +8288 4 35.176 29.229 26.5925 2.58985 10.308 -31.8228 +8289 6 30.7102 25.4463 11.6589 -5.09223 14.513 32.8165 +8290 4 30.6059 25.8179 12.6014 3.72506 -14.6402 -39.0718 +8291 4 30.6061 26.1982 11.055 2.14208 -0.820709 7.44645 +8292 6 7.34821 15.124 12.3469 -7.98455 -28.7648 8.02815 +8293 4 6.65824 14.4547 12.1585 7.38491 7.52419 4.72727 +8294 4 7.19665 15.7511 11.658 -2.78105 24.4343 -15.0907 +8295 6 16.8417 26.815 7.05419 -24.774 6.28148 -21.5195 +8296 4 17.6138 26.5995 7.5418 30.7131 -10.23 16.3776 +8297 4 17.1302 26.9688 6.14022 -2.93816 -3.28182 4.8763 +8298 6 29.5112 33.0571 30.9901 -17.2684 21.8413 -16.809 +8299 4 28.6007 32.8494 30.6893 8.91061 -10.9491 6.08618 +8300 4 29.8939 32.355 31.5124 -6.62171 -19.0922 5.25725 +8301 6 14.1054 2.12143 30.9174 -7.90077 -11.4283 37.211 +8302 4 14.0041 2.00138 31.9209 0.0297695 4.78336 -39.0496 +8303 4 13.7376 1.30679 30.5176 6.48361 9.45743 4.44265 +8304 6 15.6593 22.2688 2.88796 -26.3773 12.8308 -8.6958 +8305 4 16.4059 21.7286 3.01985 35.1738 -16.1657 6.55343 +8306 4 15.0005 21.6175 2.62854 -10.183 2.33344 0.69621 +8307 6 23.7324 29.1178 40.9691 12.375 28.71 1.88761 +8308 4 23.2563 30.0016 40.9795 15.1309 -27.3218 0.73938 +8309 4 24.7153 29.2815 40.9372 -24.8849 -3.40565 0.339466 +8310 6 38.1289 14.1609 13.7163 11.3988 23.3452 4.961 +8311 4 37.6355 13.3641 13.8052 -15.0683 -25.2976 3.04519 +8312 4 38.877 13.9408 13.1592 7.07353 -0.711776 -7.39216 +8313 6 35.2564 26.5047 15.5196 1.21661 4.3606 12.6683 +8314 4 34.5556 26.4436 14.8616 -0.145442 -0.409522 -0.299569 +8315 4 34.9009 27.0522 16.256 4.1263 -8.75979 -17.8666 +8316 6 19.0944 34.7315 16.477 3.93496 0.874554 38.8769 +8317 4 19.5342 35.6013 16.5498 -2.87948 -9.96323 -9.99674 +8318 4 19.0181 34.4301 15.5899 3.71142 3.01681 -30.4069 +8319 6 18.1805 29.7449 35.7046 18.8444 17.1873 -3.97052 +8320 4 18.2235 30.6593 35.335 -4.4784 -20.2666 13.1463 +8321 4 19.056 29.5886 36.1261 -9.76671 1.23141 -6.47371 +8322 6 54.1188 22.2659 24.9096 4.78421 -24.6774 -19.3149 +8323 4 53.6441 21.8104 24.1769 10.121 5.11789 9.9801 +8324 4 53.5075 22.9378 25.1661 -14.3198 20.1313 5.7187 +8325 6 30.3323 10.3375 34.0061 7.35563 0.641124 -2.21855 +8326 4 29.5734 10.4043 34.5817 -14.4555 0.0376959 9.72957 +8327 4 30.8213 11.1653 34.1487 -3.17747 -4.67635 -0.590304 +8328 6 38.3211 33.8974 18.5888 -1.32754 -0.89807 -0.720993 +8329 4 38.9926 33.271 18.8539 2.22312 -19.1913 3.89796 +8330 4 38.8713 34.6655 18.5317 3.84957 24.8056 -1.31283 +8331 6 22.4809 14.1697 34.431 -22.1622 -5.27184 -37.8541 +8332 4 22.5433 13.5186 33.673 0.822047 20.8222 24.5167 +8333 4 23.1773 14.0067 35.0533 16.0768 -5.18569 10.3575 +8334 6 38.0141 0.622036 2.34694 9.03481 -5.1652 10.3599 +8335 4 37.7113 1.09641 3.1189 -18.3016 16.1314 2.00329 +8336 4 38.7028 0.120019 2.79986 6.1006 -11.8827 -16.4842 +8337 6 38.8847 41.1446 10.3004 16.8495 57.0142 -12.497 +8338 4 38.6453 0.212884 10.3117 6.47193 -33.8599 -1.337 +8339 4 38.2374 40.7573 10.8541 -26.8649 -17.5582 22.9746 +8340 6 53.4109 21.9211 38.9712 27.3607 0.0645619 -10.5759 +8341 4 53.0384 21.9801 38.0859 -10.7304 2.2749 -0.0111998 +8342 4 54.3668 22.0571 38.7395 -19.1981 -5.88632 12.9741 +8343 6 39.9872 12.7205 36.288 -8.06793 35.3321 20.4333 +8344 4 39.087 12.3834 36.3725 1.18883 -9.13664 -3.11406 +8345 4 40.4905 12.1818 35.7009 7.36107 -20.124 -19.0601 +8346 6 48.4463 17.2389 40.5967 -24.7278 4.81563 12.4078 +8347 4 47.5665 17.6971 40.4852 25.7833 -12.0744 1.257 +8348 4 48.3987 16.886 41.5134 6.10343 4.05346 -12.6042 +8349 6 32.0413 9.35688 40.0251 1.84943 -9.41379 10.5137 +8350 4 32.8011 9.3156 39.4233 -4.71533 -3.42986 0.347912 +8351 4 31.8082 8.43016 40.2864 3.98001 20.4877 -6.20043 +8352 6 31.7351 22.4909 6.36481 -11.9835 4.517 5.86255 +8353 4 31.4453 21.6589 6.79738 2.31245 15.2673 -2.59345 +8354 4 31.3521 23.2372 6.88711 4.39127 -22.2776 -7.77946 +8355 6 51.0252 2.58567 21.5888 12.0252 -3.79771 4.1956 +8356 4 51.3852 1.69652 21.8042 -1.91984 13.1306 -1.09782 +8357 4 51.7712 3.19849 21.4753 -6.25067 -9.48202 2.92476 +8358 6 13.6387 22.0486 12.1519 25.289 13.6281 9.24284 +8359 4 14.4553 22.4795 12.4841 -9.12946 -7.35477 -7.44936 +8360 4 12.9422 22.6971 12.3091 -5.69931 -0.254566 -0.690626 +8361 6 23.6098 24.0343 14.6404 -2.85842 21.3712 -30.1324 +8362 4 24.3054 24.4792 15.1401 1.72137 -5.65962 3.08819 +8363 4 23.5196 24.6041 13.8393 -4.42688 -17.9982 21.1692 +8364 6 9.32217 4.85318 31.2328 11.4746 -4.61869 -4.10735 +8365 4 8.43042 4.86168 30.8848 -9.06213 4.49291 -0.279243 +8366 4 9.25495 5.26013 32.106 -3.85952 -1.36 2.0258 +8367 6 16.6786 26.3118 18.041 -30.5179 5.83101 -14.1852 +8368 4 15.8205 26.6594 17.6987 9.23568 -14.6779 7.38956 +8369 4 17.2149 27.0871 17.9121 20.6972 11.6613 1.32787 +8370 6 5.1068 13.5155 11.5503 -9.62018 18.629 -29.2057 +8371 4 4.37741 13.3629 12.1623 -7.62379 -0.222526 0.540006 +8372 4 4.70689 13.979 10.7366 10.5209 -18.4088 37.9064 +8373 6 29.6181 23.6359 8.06142 -1.81854 7.21422 -1.70755 +8374 4 29.1888 23.4521 8.90141 0.206013 -3.23773 -0.0922606 +8375 4 29.4815 24.5976 7.98987 7.61073 -10.2969 -5.72522 +8376 6 0.801466 7.54671 27.8401 6.5354 -3.49578 -14.7683 +8377 4 0.895859 7.27352 28.7573 1.78004 -0.979843 7.25552 +8378 4 1.54585 8.15528 27.6648 -11.1939 -10.5496 5.25649 +8379 6 15.4336 9.77253 0.489553 0.922542 4.3707 -1.35473 +8380 4 16.0351 9.34865 41.7726 4.14277 -6.55565 2.56274 +8381 4 15.4857 9.31476 1.34042 4.74784 -1.15717 -0.337147 +8382 6 18.8008 0.0730809 34.105 -10.3773 -6.96418 -21.8764 +8383 4 18.5081 41.5423 33.2731 5.22569 12.9238 15.5106 +8384 4 18.5071 0.998566 34.0742 -2.68781 1.40869 -5.2752 +8385 6 18.7326 30.7673 29.1559 48.9948 -22.8293 28.8452 +8386 4 19.5421 30.7479 29.7792 -35.6741 -9.01286 -31.0748 +8387 4 18.496 31.6741 29.187 -17.0068 24.787 -0.45657 +8388 6 48.459 16.4997 36.139 1.45519 10.5028 1.01521 +8389 4 47.6111 16.9857 36.2164 10.4415 -5.87096 -2.55811 +8390 4 48.4968 16.1176 35.2432 -2.18798 4.21486 5.30298 +8391 6 43.8007 0.467658 29.2569 28.3678 -13.8677 -3.77703 +8392 4 42.8971 0.305725 29.4937 -25.3214 -1.14832 5.94808 +8393 4 44.2622 41.5592 29.5347 -3.4854 12.8866 -0.12306 +8394 6 16.7282 13.8764 21.3804 -5.85841 5.25102 8.86173 +8395 4 16.2274 14.7005 21.5266 6.94274 -6.60805 -7.01164 +8396 4 16.607 13.4327 22.2267 1.29648 -4.09529 1.45702 +8397 6 17.3848 13.434 26.2514 27.8708 0.579352 -19.8612 +8398 4 18.2073 13.6243 25.7048 -28.5107 -7.2193 21.7409 +8399 4 17.5944 12.6077 26.718 -2.1357 3.12496 0.608863 +8400 6 48.1647 10.2208 23.7049 7.80266 -18.7522 13.388 +8401 4 47.9825 10.5204 24.6118 -3.05612 1.76991 -8.97221 +8402 4 48.0139 10.9468 23.1026 -1.19683 7.34816 1.26356 +8403 6 28.2773 17.9142 17.8758 3.72989 18.9709 -15.182 +8404 4 29.0682 18.432 17.6259 -4.1904 -8.84834 4.2635 +8405 4 28.5441 17.0749 18.25 8.7895 -11.8779 5.35139 +8406 6 54.0848 38.1774 23.6862 8.79068 2.20397 4.23058 +8407 4 0.0366427 38.003 23.4974 -14.1536 0.885634 -1.20583 +8408 4 53.5245 37.5494 23.203 6.54807 -0.952262 -0.611804 +8409 6 8.48984 18.3998 11.4055 -13.462 -3.57414 27.789 +8410 4 7.65602 18.6961 11.043 -9.38292 3.75479 -0.915161 +8411 4 9.09748 18.5243 10.712 30.3826 3.02886 -30.4498 +8412 6 45.9441 12.8818 11.0222 -16.4049 1.91652 -6.40765 +8413 4 46.711 12.6299 10.4835 -7.54952 -0.564906 -6.57768 +8414 4 45.1235 12.7466 10.4771 21.7466 0.735613 7.10643 +8415 6 16.2215 8.79448 14.033 27.9098 -14.9816 6.01142 +8416 4 15.5522 9.3752 13.7952 -53.829 20.9905 -11.5495 +8417 4 16.9359 9.40542 13.9326 31.9466 3.3348 3.59486 +8418 6 42.7223 13.3863 21.3918 29.8224 16.7773 6.64199 +8419 4 41.9142 12.8874 21.2836 -9.67718 -3.29752 -8.9243 +8420 4 42.6271 14.312 21.0975 -16.0363 -11.184 0.152454 +8421 6 20.9977 40.4228 16.4707 19.2311 -21.9074 5.84064 +8422 4 20.7341 40.0536 17.3362 -0.495629 5.04161 -8.05599 +8423 4 21.8212 39.937 16.2081 -24.2166 11.8961 5.45251 +8424 6 45.6397 11.4296 32.9439 38.4109 -29.1814 -9.99274 +8425 4 46.3321 10.7493 33.2028 -28.4056 24.9384 -5.22126 +8426 4 45.113 11.6624 33.7013 -7.79747 1.97566 18.4384 +8427 6 26.9602 8.8599 24.2968 13.5915 2.79356 4.8338 +8428 4 27.3951 9.75608 24.2837 -6.20264 -27.5971 5.81865 +8429 4 27.4821 8.2415 24.8764 -5.62896 20.549 -11.158 +8430 6 18.9707 2.44141 29.3655 -2.01209 17.0873 0.653095 +8431 4 18.2519 2.38593 30.0124 -1.45633 -1.83702 1.76482 +8432 4 19.0982 3.39915 29.1871 -0.208097 -9.69202 4.76181 +8433 6 8.2396 29.1642 19.724 -7.67611 -9.48635 17.3168 +8434 4 8.16332 28.9052 20.6672 2.00381 4.74558 -18.2193 +8435 4 7.79264 28.4685 19.2154 1.97612 2.42161 3.19163 +8436 6 9.03293 34.3085 18.6392 -6.8245 -3.51508 -5.57673 +8437 4 8.73043 34.3576 19.5508 2.61936 3.47829 -5.40237 +8438 4 9.19173 35.2194 18.3614 3.83285 -0.179546 -0.301582 +8439 6 10.1806 11.9309 11.2378 5.33181 -8.21116 5.18339 +8440 4 10.4199 12.8404 10.9987 -8.38943 -3.43734 -3.26379 +8441 4 9.2213 11.8063 11.1618 4.16708 15.3888 -2.40164 +8442 6 35.7388 21.6853 36.1571 -21.2187 21.2566 3.59668 +8443 4 35.0074 22.3505 36.1843 15.9506 -16.0405 0.715421 +8444 4 36.3839 21.978 36.8321 -7.05156 -5.2756 -8.86951 +8445 6 17.0774 12.5078 36.39 -5.14261 15.8003 12.7424 +8446 4 17.3404 12.7479 37.2961 -4.35419 -1.09545 -7.6232 +8447 4 17.4977 11.6659 36.234 4.71638 -15.3379 -7.50181 +8448 6 37.1607 13.034 34.2837 0.889917 6.85814 -56.1323 +8449 4 36.6144 12.2451 34.135 3.16712 2.80772 8.73621 +8450 4 37.2953 13.1592 35.1962 -1.91867 -3.10361 40.6259 +8451 6 38.9747 29.5563 13.2253 1.18838 24.1885 -12.4362 +8452 4 38.8174 28.6959 12.8484 -2.87796 -16.626 0.178868 +8453 4 38.7606 29.548 14.1582 -0.666122 -3.30753 9.89159 +8454 6 0.17037 29.343 29.4884 -1.26324 3.91124 -27.2421 +8455 4 0.785297 28.6867 29.1327 1.78511 -2.78426 6.40223 +8456 4 54.9717 29.8735 28.6813 -2.47422 -4.8209 18.3172 +8457 6 15.9286 0.264913 12.7638 2.77369 8.97324 -0.606717 +8458 4 15.3998 0.564835 11.9867 -4.35739 -9.72902 15.1241 +8459 4 15.3918 41.7399 13.4663 -4.26125 7.58409 -15.055 +8460 6 3.98508 11.9472 8.79546 -10.0423 -23.9471 10.8905 +8461 4 4.30821 11.7435 7.92681 6.40121 -7.70989 -16.6116 +8462 4 3.96465 12.8834 8.77069 -2.75643 37.1798 9.03734 +8463 6 24.0517 23.6768 19.9772 9.9875 -0.396554 0.578582 +8464 4 23.5025 22.9354 19.7663 -8.47693 -16.0962 -5.40355 +8465 4 23.4442 24.2751 20.4024 2.14545 13.6845 6.88162 +8466 6 4.48152 2.30986 23.9923 -27.0109 23.4084 27.373 +8467 4 4.59263 2.40669 23.0716 9.73085 -3.6317 -36.525 +8468 4 3.6479 2.81506 24.1139 10.3345 -10.6947 10.8816 +8469 6 33.0856 27.6588 33.8383 -8.68317 -6.77689 0.893276 +8470 4 33.3543 28.5605 33.6822 -2.66039 14.7626 -6.22211 +8471 4 33.7694 27.2718 34.3804 4.93538 -5.90298 8.33006 +8472 6 11.4012 21.7076 6.08442 -20.9181 -7.28975 6.20623 +8473 4 12.3452 21.6439 6.06884 23.6791 -0.506282 -5.12853 +8474 4 11.1369 22.1078 5.25059 3.06155 -0.534748 -3.52863 +8475 6 37.2275 13.5312 23.6107 -13.7454 14.8127 9.96245 +8476 4 37.2011 14.0176 24.4689 -4.04457 -8.03454 -15.7104 +8477 4 38.0738 13.1109 23.5305 19.2281 -7.80113 -1.86698 +8478 6 5.00929 21.0475 33.3676 1.03993 27.0325 -33.9401 +8479 4 4.24931 21.2691 32.771 13.0002 -8.94008 10.7478 +8480 4 4.70945 20.492 34.0664 -10.4226 -16.4153 18.9759 +8481 6 18.2024 37.5737 26.9347 11.0126 -1.54132 -8.69207 +8482 4 17.8515 38.4557 27.1129 2.92195 -1.85995 -3.39903 +8483 4 18.9058 37.6892 26.2602 -8.80934 -3.84756 9.96821 +8484 6 19.7475 16.1502 4.67922 -0.59461 -5.69737 6.80756 +8485 4 18.938 15.9829 5.17999 -0.503733 6.42822 -3.53139 +8486 4 20.452 15.899 5.29485 1.51569 2.54074 -3.7554 +8487 6 54.0588 32.502 15.5791 2.11509 -30.3723 -27.0265 +8488 4 54.9193 32.2734 15.944 -2.03587 2.87368 2.60187 +8489 4 53.7148 33.1889 16.1175 -9.21817 24.1266 16.9863 +8490 6 31.1319 3.81908 36.7331 -8.52453 -12.3767 5.98224 +8491 4 31.0251 4.01663 37.6709 2.24281 6.85123 1.97341 +8492 4 30.7371 2.93942 36.6325 4.48759 4.53933 -4.77061 +8493 6 11.8397 14.3559 5.95013 17.712 13.5011 32.6048 +8494 4 11.8882 13.4483 5.64785 3.21485 -4.29204 1.16864 +8495 4 12.4103 14.428 6.79608 -23.3682 -9.2254 -38.5841 +8496 6 30.4732 33.6903 6.46877 -20.5926 30.9984 10.0988 +8497 4 30.0823 33.146 7.15741 -0.571027 -8.82817 5.88036 +8498 4 31.0368 33.1406 5.95739 18.3645 -25.6031 -16.3825 +8499 6 12.7874 0.539502 21.6719 -8.5062 -5.44338 -19.1545 +8500 4 12.0427 0.939271 21.1459 16.6961 -1.79193 22.1421 +8501 4 12.8959 0.982969 22.5241 -5.23507 7.86641 1.50036 +8502 6 52.7588 7.2218 26.198 16.8025 28.3515 6.33153 +8503 4 53.4065 7.96379 26.3423 -21.978 -17.2249 -4.05545 +8504 4 53.0631 6.80021 25.3976 -2.37526 -6.61619 -6.13258 +8505 6 39.7335 40.8867 3.73325 7.25622 8.93714 -16.4459 +8506 4 39.3445 40.0379 3.8542 -7.03998 -23.1188 -2.87281 +8507 4 39.6833 41.2661 4.59764 3.93702 15.0893 17.324 +8508 6 20.121 31.9222 21.9838 -6.71526 -6.20654 6.86321 +8509 4 19.4522 31.9772 22.708 13.7594 -4.46219 -12.9776 +8510 4 20.3423 32.8279 21.7497 1.41177 8.86705 -0.575134 +8511 6 12.8675 35.0031 4.45346 44.828 -17.7313 4.60062 +8512 4 12.2237 35.6716 4.40701 -39.658 29.9319 -2.18346 +8513 4 13.7076 35.4677 4.24983 -7.53722 -6.26381 -0.0905995 +8514 6 24.0625 33.6591 24.8433 7.47563 8.71661 -6.22666 +8515 4 23.7256 32.9086 24.3593 -5.011 -9.84395 -6.229 +8516 4 24.8651 33.8891 24.3525 -1.08488 0.504411 0.449776 +8517 6 40.1566 40.8925 22.745 3.65995 -18.1772 23.084 +8518 4 39.459 41.1173 22.1514 -10.4135 8.7075 -19.9273 +8519 4 39.655 40.5713 23.5068 11.7186 -0.819555 2.88668 +8520 6 15.5608 2.83174 38.4548 -17.961 4.93292 18.3513 +8521 4 14.8017 3.44348 38.6509 23.1729 -8.01231 -13.692 +8522 4 16.317 3.27039 38.0376 1.48109 9.53369 -0.90723 +8523 6 41.0116 9.17543 16.9495 15.4695 -4.08523 -13.4682 +8524 4 41.9148 8.77619 16.8957 -14.8555 5.86712 4.74383 +8525 4 40.5932 8.80873 17.73 -3.00249 -3.47282 8.63794 +8526 6 43.1871 41.3934 9.57744 -8.69666 -18.4537 3.1119 +8527 4 42.3844 40.9156 9.26306 10.8189 9.37287 1.53096 +8528 4 43.2581 0.273962 9.04681 -5.03874 9.79533 -5.6553 +8529 6 24.9044 37.9223 30.7828 -39.5154 -3.84946 22.9815 +8530 4 23.9949 37.8093 31.2426 42.0603 4.56965 -20.1335 +8531 4 24.7148 38.3736 29.9542 -2.24489 2.04808 -5.58176 +8532 6 2.22015 5.33054 16.4399 10.309 -8.52293 4.98471 +8533 4 1.84892 4.56193 16.8809 -9.36945 -1.25887 4.31387 +8534 4 3.13742 5.05729 16.2666 0.349453 6.20437 -4.74718 +8535 6 1.39717 14.946 19.1428 25.1228 15.6369 3.14315 +8536 4 0.624759 14.5201 18.7755 -11.3456 -6.79531 3.66607 +8537 4 1.29195 14.9418 20.1112 -7.64559 -2.97115 -5.19376 +8538 6 34.323 26.551 23.7054 -6.89575 15.1076 -7.90432 +8539 4 33.5377 26.6273 23.1515 0.482254 10.7241 -2.26295 +8540 4 34.2298 25.6735 24.0419 5.3831 -21.6418 13.1607 +8541 6 41.9187 21.8289 37.5387 -12.5221 18.6557 -0.654717 +8542 4 42.0641 21.2774 38.3263 -4.73604 7.9145 -4.0056 +8543 4 41.3184 22.5612 37.831 11.9642 -17.2916 1.51119 +8544 6 39.4187 37.6728 12.6286 4.8532 5.57593 -2.65087 +8545 4 38.7905 38.0203 13.2933 13.4683 3.10916 -9.30227 +8546 4 40.0129 38.4033 12.3216 -17.7433 -13.1833 12.1033 +8547 6 30.24 35.8848 2.88572 49.7685 -5.59713 18.4489 +8548 4 29.7974 35.0543 2.80033 -9.93294 -19.906 -6.06696 +8549 4 29.6668 36.5692 2.63166 -32.6151 32.1739 -11.9765 +8550 6 50.3574 12.2906 11.0327 -10.5999 -17.0186 -10.0309 +8551 4 50.5337 13.0768 11.5186 9.60091 28.0994 7.49192 +8552 4 50.105 11.6994 11.7365 -4.43527 -18.2768 5.14926 +8553 6 38.4177 1.51331 34.6454 7.78381 -17.0522 33.0946 +8554 4 38.2699 2.04814 33.8899 -7.54861 16.9144 -29.9652 +8555 4 38.0471 0.642488 34.4678 -6.5188 -5.83242 -9.72252 +8556 6 23.4539 32.2409 29.2188 -19.2438 22.9381 45.5983 +8557 4 24.0079 32.8299 28.7229 8.54827 0.527122 -15.0299 +8558 4 23.2413 32.797 30.0413 4.80705 -31.5817 -31.7916 +8559 6 36.5701 38.8746 8.90535 32.3223 -9.33237 29.2552 +8560 4 35.9325 39.4424 8.49935 -20.4423 23.0824 -8.61697 +8561 4 36.7801 39.1579 9.82993 -12.7327 0.605838 -19.3651 +8562 6 35.8737 15.8498 32.4386 8.92141 19.9053 -4.5399 +8563 4 36.1418 15.4504 33.2665 1.19933 -3.86396 7.25653 +8564 4 36.5179 16.5897 32.2945 -14.9335 -15.4114 1.1633 +8565 6 22.2892 21.8291 41.5841 -16.2626 10.7882 17.5339 +8566 4 22.1223 22.8053 41.6744 16.5914 -23.4811 -7.73209 +8567 4 23.1242 21.6534 41.1409 10.4107 9.35007 -4.50107 +8568 6 24.3606 38.6964 37.0146 17.4204 12.5043 -4.63866 +8569 4 25.2779 39.064 36.9978 -17.1771 -5.52971 -1.04157 +8570 4 24.4186 37.9719 37.6407 -4.78215 -9.12154 5.30794 +8571 6 45.8441 22.068 16.038 0.340293 -0.250982 -17.8101 +8572 4 46.1771 22.3609 15.1533 -8.50833 -8.1377 19.1007 +8573 4 45.4344 21.1785 15.9468 10.2139 13.0315 -4.03882 +8574 6 34.0918 26.1359 39.6112 38.0511 -8.91464 13.1738 +8575 4 33.1848 26.2338 39.3827 -25.4265 4.60567 1.8853 +8576 4 34.221 26.2032 40.5833 -12.0295 -1.62025 -11.2558 +8577 6 7.22533 36.1661 23.281 -59.3132 -5.14125 -34.652 +8578 4 7.26364 37.0581 22.9295 6.20379 9.34593 -2.3157 +8579 4 7.97006 36.0735 23.8015 59.451 -4.11437 40.0555 +8580 6 29.1637 40.7448 9.14206 -2.51826 7.72751 -13.9009 +8581 4 29.0444 40.3656 8.22324 15.9504 -2.90487 33.8878 +8582 4 29.7314 40.248 9.77766 -4.36215 -9.31282 -20.9127 +8583 6 29.3678 11.2357 1.30083 -35.1077 14.24 19.1284 +8584 4 28.4669 11.4731 0.940057 29.2946 -5.02339 11.2991 +8585 4 29.318 11.4379 2.27092 4.83193 -7.95866 -28.0539 +8586 6 30.9732 3.71267 14.0776 15.2348 -46.8383 -31.5788 +8587 4 31.4582 2.88428 14.3733 -12.5046 34.6753 7.46482 +8588 4 30.8397 3.49874 13.1133 -3.67459 15.4991 23.3176 +8589 6 29.7056 15.2804 38.2794 -11.9618 14.5562 -33.6413 +8590 4 30.2702 15.1354 39.0168 20.1567 -4.59268 23.419 +8591 4 30.0841 16.0123 37.7308 -6.59039 -15.0688 15.6005 +8592 6 36.6264 0.310111 29.1514 -5.04796 -7.83703 -2.09784 +8593 4 37.4271 0.819379 29.3706 -8.93441 4.46737 -4.0897 +8594 4 35.9914 0.856083 28.6484 15.2391 -5.29618 7.37908 +8595 6 47.6417 0.116275 23.248 13.5287 8.94531 -12.2883 +8596 4 47.0119 0.433387 23.8864 -15.3927 3.59754 12.8324 +8597 4 47.4641 41.0946 23.1357 -2.49679 -12.2922 2.24912 +8598 6 7.90637 37.1762 29.9388 8.54368 22.8184 26.8453 +8599 4 7.85301 37.2098 30.9449 3.45275 -3.37357 -41.2712 +8600 4 8.44496 37.9737 29.6897 -17.0006 -23.7003 10.0801 +8601 6 38.9296 24.2329 12.6383 15.5219 -16.6974 -22.776 +8602 4 37.9787 24.1601 12.7323 -9.9748 0.376678 1.49713 +8603 4 39.1449 23.5705 11.9215 -5.67631 22.059 20.3409 +8604 6 21.3179 26.2613 36.7933 11.7928 19.07 -1.51604 +8605 4 20.8397 25.6962 36.2015 -9.60619 -6.53459 -13.3894 +8606 4 21.5182 25.6957 37.5187 2.0605 -10.1459 21.1123 +8607 6 28.2262 23.3351 24.9913 6.08955 -0.748437 0.460504 +8608 4 28.2308 24.0016 25.6964 4.22655 -6.81745 -1.24962 +8609 4 29.0479 22.8075 25.0363 -13.73 7.51762 2.95505 +8610 6 38.3897 39.5713 14.5774 34.0997 -9.77678 18.0089 +8611 4 38.4779 38.8655 15.2987 -6.58584 29.8461 -29.0755 +8612 4 39.3026 40.0121 14.5422 -41.1029 -19.3921 -1.23505 +8613 6 26.0587 6.01626 38.1331 -7.56489 -16.2073 9.45163 +8614 4 26.364 6.92283 38.0032 14.5247 -0.467326 2.92393 +8615 4 26.7573 5.38712 38.4414 -3.391 26.9876 -7.34507 +8616 6 52.1178 17.2513 22.5128 -10.8492 5.54118 7.42996 +8617 4 52.8997 17.6733 22.1718 9.92427 15.7211 -4.0445 +8618 4 52.2219 16.3395 22.2718 -2.102 -18.0313 -4.16051 +8619 6 39.531 30.2011 31.4754 1.32431 5.33104 20.3977 +8620 4 40.1389 30.6029 32.1578 -26.1612 -12.9519 -10.6425 +8621 4 38.6407 29.9778 31.8528 28.462 12.4065 1.81878 +8622 6 19.6595 6.91666 12.7659 -14.5008 4.80913 14.0157 +8623 4 19.6887 6.47111 13.6446 7.23462 -2.42447 -18.0556 +8624 4 20.266 6.55226 12.115 5.2883 -10.9354 6.21868 +8625 6 32.4266 37.4954 40.1172 13.7501 31.88 -47.4625 +8626 4 32.7425 36.6266 39.9032 -2.48661 -20.9779 5.59445 +8627 4 32.1419 37.5817 40.9958 -11.8933 -10.3197 48.8363 +8628 6 39.7596 0.337115 6.09995 15.1421 -1.66777 24.2876 +8629 4 40.1534 1.22219 6.08152 -5.11901 -0.972083 -7.53812 +8630 4 40.1657 41.8549 6.90018 -9.37436 -2.20237 -11.3555 +8631 6 28.7751 10.1584 29.138 -2.01192 2.80513 -2.93319 +8632 4 27.8238 10.1744 29.001 -3.57801 1.81269 -4.50746 +8633 4 28.8919 9.80572 30.0274 6.34341 -2.0407 -1.56061 +8634 6 28.3442 21.074 10.6333 2.67716 -1.32955 -8.08167 +8635 4 28.7162 21.9756 10.7458 1.68682 -14.6392 -2.70928 +8636 4 28.9848 20.5267 10.1317 -8.30024 16.2649 10.4277 +8637 6 27.0693 28.6863 20.8775 28.7719 -2.37794 4.3254 +8638 4 27.7298 29.2434 21.3283 -4.93173 -3.86203 -1.8773 +8639 4 26.2334 28.9344 21.2444 -24.6691 6.36732 10.1211 +8640 6 39.6873 13.9804 33.4544 10.1398 -5.61125 10.7915 +8641 4 40.0465 13.7022 34.3167 -4.86 2.4669 -10.6871 +8642 4 38.7726 13.6755 33.4723 -5.1401 -2.85022 0.606476 +8643 6 25.4597 11.6576 34.3181 14.491 -28.0098 33.8508 +8644 4 24.8514 11.0162 34.7619 5.36553 12.2612 -15.2396 +8645 4 25.0161 12.1454 33.6493 -21.152 12.7672 -16.4478 +8646 6 27.5131 37.6326 21.427 -19.9573 -21.9997 -23.7283 +8647 4 28.2253 37.2064 20.96 8.67225 -9.05343 -17.242 +8648 4 27.9596 38.068 22.1137 20.557 20.5047 35.0331 +8649 6 30.5914 20.0695 28.6348 27.7431 -17.6396 19.2377 +8650 4 30.9836 19.3645 29.1801 11.8534 20.0629 -12.5158 +8651 4 29.6982 19.8076 28.6872 -39.6618 5.20089 -10.7407 +8652 6 42.3778 1.85684 14.9393 25.4983 -1.50621 30.9456 +8653 4 41.9471 2.41032 15.6124 -5.43016 1.03086 -4.74891 +8654 4 41.8361 1.80616 14.1675 -19.8596 2.00334 -17.6468 +8655 6 12.1616 12.5321 19.523 -14.5305 -6.69845 -4.01711 +8656 4 12.9939 12.0448 19.446 -0.641831 -5.10207 -0.17564 +8657 4 11.4028 11.9007 19.4323 17.6183 8.93718 0.635936 +8658 6 19.2173 1.21358 16.3673 12.2327 1.89672 9.92834 +8659 4 19.755 0.600796 16.911 -5.77615 9.45405 -9.5745 +8660 4 19.8129 1.9499 16.1364 -2.75311 -6.47505 -0.557351 +8661 6 9.48027 16.145 27.6887 18.4383 23.7652 -21.1678 +8662 4 9.95062 16.009 26.8224 -12.6846 -2.19341 25.2173 +8663 4 9.19893 15.3052 28.0262 -3.30777 -17.5687 0.945009 +8664 6 40.4566 26.1709 24.7821 -20.4805 41.2174 -0.532491 +8665 4 40.3628 26.7039 25.5991 10.1463 -19.7663 1.05084 +8666 4 40.0809 26.8306 24.1463 10.2053 -25.1837 1.88999 +8667 6 47.6675 17.6506 18.0225 -30.0634 41.3074 12.2788 +8668 4 48.2543 17.9981 18.7254 0.401995 -10.3127 -9.33209 +8669 4 46.9068 18.3177 18.0388 29.0716 -28.5939 -1.2112 +8670 6 36.6158 25.2629 4.18774 29.3736 28.0527 4.32129 +8671 4 36.5214 25.5758 5.09839 -16.0305 -5.04511 0.138651 +8672 4 37.2819 25.9232 3.86538 -16.6324 -17.2389 -6.3952 +8673 6 39.5728 35.3879 29.6636 12.278 22.7044 -7.26925 +8674 4 39.0499 34.5938 29.661 -5.91236 -8.06683 2.48368 +8675 4 39.3907 35.9006 30.4607 -1.7908 -9.53931 -1.38728 +8676 6 0.412001 14.6096 13.3342 2.26376 -2.5079 -14.7045 +8677 4 54.7802 15.2759 13.6175 -3.32355 6.27336 -0.974202 +8678 4 0.516441 14.0579 14.0961 4.60085 -12.9246 15.0473 +8679 6 12.196 27.3305 8.43326 10.0473 13.6833 14.0535 +8680 4 13.031 26.8669 8.51701 2.31971 -16.5604 -6.51009 +8681 4 12.4357 28.1833 8.85089 -17.0888 -3.60228 -10.1051 +8682 6 36.9057 14.8161 21.1198 30.6025 20.2317 -25.7914 +8683 4 37.0125 14.4244 21.9807 1.92342 -10.2074 20.832 +8684 4 37.7936 15.2053 20.874 -24.9082 -16.5351 5.08732 +8685 6 20.8486 4.94275 21.105 17.9022 -6.61396 -0.309651 +8686 4 20.374 5.67415 21.5228 9.17185 2.06744 3.08402 +8687 4 21.7751 4.88103 21.448 -24.8745 1.45604 -2.42669 +8688 6 36.7441 1.80601 7.63303 -8.86792 14.8212 -18.8361 +8689 4 36.3577 2.71345 7.77493 14.0998 -30.8697 16.0099 +8690 4 36.9898 1.34966 8.45182 -6.21638 14.7491 3.51078 +8691 6 12.2291 31.5076 37.4606 -20.8205 4.71929 16.9336 +8692 4 12.7789 31.2189 36.7301 -1.71439 -5.19212 -6.77065 +8693 4 11.3837 31.0118 37.4916 13.4088 3.21935 -3.86138 +8694 6 38.9875 41.6041 16.8806 -4.97036 -4.86794 -9.64455 +8695 4 39.4307 41.5716 16.0177 3.10466 0.790549 7.7281 +8696 4 39.367 0.410173 17.3903 6.57234 9.13046 2.45051 +8697 6 31.8971 27.2651 22.2536 0.475946 9.95506 -26.8482 +8698 4 31.2288 26.6192 22.5148 1.53167 3.01995 -0.700727 +8699 4 31.6701 27.5469 21.3168 1.33988 -13.0026 32.8364 +8700 6 42.7373 9.18402 25.5752 -16.5205 -8.12573 12.5156 +8701 4 42.0715 8.82875 24.9549 8.97347 3.93682 -3.18445 +8702 4 43.4726 9.55718 25.0966 9.17117 4.66181 -14.1392 +8703 6 50.9317 28.1762 25.3585 1.81467 11.9603 16.0249 +8704 4 50.4332 27.6858 24.699 -7.797 -4.30978 2.61883 +8705 4 50.6061 27.9816 26.259 1.82058 -3.16123 -16.2825 +8706 6 43.2019 19.6758 30.9261 -60.5069 12.608 18.1565 +8707 4 44.1121 19.7947 30.8273 58.227 11.7487 -4.80009 +8708 4 42.8317 20.4979 31.3452 14.2318 -14.5845 -6.94071 +8709 6 30.6579 14.0392 40.8099 -3.90856 28.8453 32.4485 +8710 4 30.2625 14.437 41.6588 6.78025 -22.1962 -33.7862 +8711 4 30.2388 13.192 40.6401 -8.31431 -9.09038 5.19898 +8712 6 20.9126 15.487 23.0255 1.81996 -1.2716 -0.577536 +8713 4 20.3529 16.1851 23.4151 9.86352 -5.06847 -1.26552 +8714 4 21.845 15.6804 23.2451 -11.0139 0.781722 1.09061 +8715 6 34.2266 0.759926 35.8266 5.91607 -35.831 36.3238 +8716 4 34.6699 1.4486 36.3596 -6.19332 -9.6922 -6.67054 +8717 4 34.0788 41.8551 36.4474 5.42693 41.8664 -30.5853 +8718 6 38.9146 36.9114 35.918 21.2173 -10.8751 17.2864 +8719 4 39.7829 37.095 36.338 -12.434 5.66027 -11.9648 +8720 4 38.7157 36.033 36.27 -5.46808 2.11761 -7.10044 +8721 6 45.1412 25.209 22.7799 -9.21588 11.7282 35.1943 +8722 4 44.1635 25.1535 22.9277 18.3683 -4.67801 -8.38153 +8723 4 45.395 24.8019 21.9606 -9.08047 -9.94082 -17.9945 +8724 6 40.6079 0.819632 35.9543 -10.1658 30.0784 -5.29357 +8725 4 40.5743 41.7978 35.9297 8.39322 -37.6139 4.80851 +8726 4 39.8853 1.04128 35.3423 10.5918 6.58535 9.58714 +8727 6 11.0481 28.354 35.0263 -7.05837 2.15472 6.15391 +8728 4 11.0065 27.7661 35.7937 6.20016 -1.50115 -1.31869 +8729 4 10.2774 28.923 35.1598 -2.00076 2.29074 -4.05614 +8730 6 20.214 13.5993 35.8619 28.0429 -16.4719 23.5579 +8731 4 19.4963 13.9327 35.3857 -45.1468 12.1599 -23.9045 +8732 4 20.9404 14.0304 35.4284 21.7873 4.64258 -6.99651 +8733 6 39.6259 5.13927 1.77541 6.3837 10.5905 23.0009 +8734 4 38.815 4.76887 1.43754 -8.89155 -4.8304 -7.9643 +8735 4 40.2998 5.10051 1.09544 5.70124 1.55861 -13.0764 +8736 6 30.2644 30.8765 32.4376 2.45351 13.5189 11.7538 +8737 4 29.6638 31.1848 33.1457 1.37952 -7.29152 -6.97913 +8738 4 29.9065 30.0722 32.0512 -6.5155 -7.29863 -0.0927806 +8739 6 14.5561 10.991 22.8667 10.081 16.7623 43.7388 +8740 4 15.1677 11.6459 23.3133 -13.9792 -18.4015 -26.7579 +8741 4 13.9431 10.829 23.6181 3.59137 -7.6484 -17.8174 +8742 6 20.7554 13.9367 3.0184 -22.7431 -13.2276 -14.851 +8743 4 19.9027 13.7405 2.57467 24.082 -4.954 3.77469 +8744 4 20.4786 14.7044 3.49738 5.42185 19.6619 18.2233 +8745 6 41.2999 4.28373 12.6115 -5.11846 11.2121 16.06 +8746 4 40.5902 3.66826 12.7964 -5.45414 -3.74116 2.1628 +8747 4 41.646 4.04628 11.766 6.8814 -9.70345 -22.8074 +8748 6 10.8486 24.7151 21.7079 -22.0181 20.7635 -2.99902 +8749 4 10.06 25.055 21.1824 26.1755 -20.3138 8.68391 +8750 4 11.196 23.8735 21.3742 -8.74412 -0.217035 -8.2032 +8751 6 53.5851 20.8962 34.3615 -20.5776 4.99959 -7.54911 +8752 4 54.5312 20.9399 34.3174 23.7346 3.60458 -0.717784 +8753 4 53.3344 20.0378 34.731 7.46747 5.54606 -4.26157 +8754 6 14.8822 4.84805 30.4483 -9.71325 -6.00753 -19.6684 +8755 4 14.771 4.94284 29.4789 1.77408 0.90497 14.7496 +8756 4 14.5561 3.94513 30.5986 4.49673 6.24836 5.5759 +8757 6 48.9024 37.1196 13.1149 -36.5603 24.8322 -14.1851 +8758 4 47.9606 37.2057 13.4129 22.1922 -3.12109 -3.19476 +8759 4 49.2987 36.4589 13.6532 13.3268 -16.5999 12.901 +8760 6 26.8059 19.3169 7.54434 -4.26945 -4.42367 7.83904 +8761 4 27.1766 18.4867 7.22339 -3.92405 -4.32352 -1.07463 +8762 4 27.3968 19.9842 7.20607 8.782 12.6164 -5.40832 +8763 6 17.6305 11.9358 39.0864 -20.6439 9.19078 16.9487 +8764 4 18.5077 11.609 39.0209 28.8526 -12.5757 -8.06323 +8765 4 17.5232 12.1203 40.0373 -6.81014 1.23205 -8.73836 +8766 6 49.927 14.591 8.61416 15.5742 -26.1486 -8.96269 +8767 4 49.2009 13.9524 8.72368 2.87529 10.9098 3.94828 +8768 4 49.6414 15.4659 8.85563 -10.1676 20.5637 7.32703 +8769 6 32.3582 34.9735 31.5167 -0.414276 11.4895 24.1707 +8770 4 32.1283 34.3825 30.8126 -1.81559 -4.89127 -12.898 +8771 4 32.4479 35.8663 31.1601 -0.97656 -3.19104 -3.1743 +8772 6 11.821 22.2226 21.3194 1.12988 -20.2292 -31.7924 +8773 4 12.2035 21.6949 20.5593 -17.646 16.3031 19.3587 +8774 4 12.5076 22.1609 21.967 14.4856 1.86701 17.8995 +8775 6 33.8479 9.95925 13.6297 5.85555 4.94861 0.641841 +8776 4 32.9412 9.60258 13.4965 20.4646 2.44791 -13.0803 +8777 4 34.46 9.81143 12.8638 -25.0852 -4.3509 9.75457 +8778 6 25.5216 36.3896 1.4985 -3.83916 -1.90754 -5.44184 +8779 4 26.1733 36.851 0.947779 -3.43756 3.58217 3.68691 +8780 4 24.6678 36.8514 1.38848 10.8858 -3.23471 -1.95008 +8781 6 26.2654 10.5456 9.75524 -44.5011 8.64206 25.1655 +8782 4 25.6084 11.269 9.60979 18.788 -4.56637 -6.88642 +8783 4 25.8198 10.0845 10.5139 21.0346 7.54764 -16.1236 +8784 6 25.0247 0.792222 40.9035 16.6629 9.7536 -9.8108 +8785 4 25.2766 0.410293 40.0414 -7.0744 -0.853038 7.71488 +8786 4 25.4535 1.67289 40.8914 -6.39875 -10.0211 5.33714 +8787 6 46.2514 3.92331 24.811 2.29787 -10.4124 3.565 +8788 4 46.4476 4.07649 23.8793 1.84574 -7.0337 -1.43198 +8789 4 46.0806 2.96577 24.928 -3.00701 8.9366 -8.52535 +8790 6 21.593 13.605 29.211 2.46069 1.87638 12.7155 +8791 4 21.5518 14.2847 29.9136 -0.977025 -6.07097 -8.18011 +8792 4 21.3035 14.062 28.4178 -1.02829 3.62716 -1.29843 +8793 6 36.772 38.3747 0.364057 -13.57 -14.6746 -5.92565 +8794 4 36.4241 39.1227 0.863015 -2.10343 5.30459 -0.282121 +8795 4 36.0255 37.7419 0.250491 13.2024 11.0478 3.68109 +8796 6 19.3024 17.6377 24.0664 34.4056 30.1631 -22.0465 +8797 4 18.4191 17.3498 24.1437 -40.9446 -15.7866 5.54764 +8798 4 19.2946 18.2748 23.3003 0.347271 -14.2409 17.5238 +8799 6 23.1729 12.6936 3.50527 -23.4203 -1.67393 -9.32385 +8800 4 22.2599 12.987 3.28408 10.1497 2.83055 6.60862 +8801 4 23.2366 11.8468 3.05081 2.04707 -0.882582 2.79058 +8802 6 37.8929 8.88926 35.4532 -15.1513 -19.5409 -35.7954 +8803 4 38.8496 8.85033 35.2802 -3.80753 -1.00094 -0.145651 +8804 4 37.4409 8.32345 34.738 24.7998 24.8105 28.8968 +8805 6 14.3214 15.124 36.1936 10.1777 -8.45579 -11.337 +8806 4 15.1189 15.6285 36.3983 0.383997 -0.909139 3.4786 +8807 4 13.728 15.2114 36.9249 -8.84751 6.7001 14.2991 +8808 6 35.0764 0.951221 33.027 4.39995 -0.747562 -23.3066 +8809 4 34.9707 1.92678 33.0471 -0.901583 -14.825 16.9845 +8810 4 34.929 0.489106 33.8671 -4.79444 18.9729 2.67887 +8811 6 50.9368 0.508345 17.9996 -16.1068 -2.11236 -10.8013 +8812 4 50.7363 1.3993 17.6607 6.59543 -7.82408 5.75367 +8813 4 50.2126 41.8571 17.6452 15.113 5.01242 7.08044 +8814 6 26.2276 30.5707 0.943679 2.98972 25.4521 29.679 +8815 4 26.9747 31.0717 1.30878 -11.5718 -5.07384 -0.177367 +8816 4 26.5685 30.1289 0.190254 7.28539 -15.5247 -23.6744 +8817 6 18.5631 38.2963 4.56281 15.0547 -0.00169581 -1.07608 +8818 4 17.6313 38.4808 4.44067 -9.04909 6.52025 -3.84653 +8819 4 19.0145 38.7079 3.79419 -7.75189 -5.39823 9.30868 +8820 6 31.1327 5.08368 4.10816 20.0095 -18.3558 -6.33253 +8821 4 31.8391 4.51927 4.54922 -26.0459 18.0586 -17.7145 +8822 4 31.2112 4.96997 3.12633 -1.20575 2.29654 19.098 +8823 6 26.4386 21.9021 1.48262 11.6176 -12.3641 -2.34526 +8824 4 26.4119 22.77 1.11333 -7.24657 26.8604 -8.21156 +8825 4 27.3591 21.6321 1.37052 -1.3799 -4.61827 0.12427 +8826 6 39.218 11.6975 22.8013 10.5737 17.0434 4.86912 +8827 4 39.8837 11.6898 23.5135 -8.12783 -9.21376 -3.17514 +8828 4 38.7576 10.8611 22.7762 -0.316566 -9.51531 5.7902 +8829 6 13.6104 36.3454 30.6448 12.2201 31.8005 15.4331 +8830 4 13.9411 37.0787 31.1944 -5.64032 -6.12374 -20.8561 +8831 4 13.4819 35.6769 31.3099 -5.82879 -19.5305 -1.97286 +8832 6 50.5737 9.8729 9.34449 -28.5439 -15.8542 -0.594603 +8833 4 49.6941 9.5296 9.68217 24.5077 10.0039 -8.16891 +8834 4 50.7802 10.6382 9.87905 1.56032 8.49656 8.37591 +8835 6 49.6568 40.2957 22.5808 3.13406 -4.17489 -1.45496 +8836 4 49.9643 39.4131 22.2832 -6.04563 10.523 5.74674 +8837 4 49.4657 40.2311 23.537 6.08697 -6.10842 -7.72776 +8838 6 7.19984 41.3227 28.8903 -1.52952 20.6044 28.9443 +8839 4 7.18166 41.5789 29.8666 2.82963 -8.74683 -37.3978 +8840 4 7.33954 0.237732 28.3754 1.09714 -11.2116 9.436 +8841 6 13.0357 18.018 25.3358 19.442 16.9905 44.3108 +8842 4 13.6166 18.1186 24.5548 -1.12298 4.17303 17.3747 +8843 4 13.5323 18.3306 26.2146 -21.9746 -20.4015 -59.5043 +8844 6 50.052 19.589 2.43093 38.9512 -4.48133 -22.8803 +8845 4 50.7424 19.2598 1.79532 -23.4729 1.49397 14.1456 +8846 4 50.5528 20.298 2.8491 -7.87613 8.00017 8.65361 +8847 6 28.349 40.9814 24.5177 14.9096 -9.01222 -0.77751 +8848 4 28.8235 40.5955 23.7606 -4.31864 4.07524 4.80921 +8849 4 27.7156 41.5877 24.1507 -14.6867 11.3415 -7.76415 +8850 6 19.4129 5.36023 29.5381 -15.1481 -17.3665 11.3948 +8851 4 20.1134 5.96028 29.2689 3.1753 8.4576 0.913483 +8852 4 18.7407 5.8353 30.064 8.44892 1.72514 -6.85652 +8853 6 35.3149 40.1584 22.2743 -5.4761 3.67764 -22.0922 +8854 4 35.6772 39.8166 23.0859 3.70556 0.822605 11.3301 +8855 4 35.3088 41.1243 22.2924 6.6179 -0.993945 11.5959 +8856 6 16.1846 33.7767 9.75922 -0.358556 8.53088 17.0233 +8857 4 15.9516 33.2005 9.03859 1.48669 -13.8429 -11.0903 +8858 4 15.6081 34.5411 9.70154 -4.21994 3.45608 -1.0308 +8859 6 17.3638 40.6569 20.2187 0.0478101 13.797 12.0053 +8860 4 17.2553 39.7868 20.6094 -1.96745 -8.64858 -4.42208 +8861 4 17.5346 41.2369 20.9867 0.609446 0.00823871 -10.958 +8862 6 20.5168 9.71855 9.57392 23.3053 8.23996 -15.5036 +8863 4 21.1612 10.0129 10.2371 -5.46071 -1.58749 -5.90152 +8864 4 19.8092 9.36498 10.0856 -20.4585 -11.5711 12.7624 +8865 6 47.4431 20.1927 21.3797 46.3705 -23.5901 12.8176 +8866 4 48.2534 19.5912 21.2825 -32.1103 24.8918 7.30718 +8867 4 46.9863 20.0806 20.5604 -17.463 -0.0836882 -22.1962 +8868 6 38.4119 40.7863 37.8131 4.58972 -16.3007 -8.86139 +8869 4 38.2015 41.716 37.7675 -2.07213 19.1933 -0.538509 +8870 4 38.1163 40.4897 38.6817 -2.89344 0.451293 5.51523 +8871 6 4.78246 1.95264 13.1142 -0.962758 -11.3299 -4.56483 +8872 4 4.86308 1.24617 12.4504 1.09441 11.0888 1.2667 +8873 4 4.58181 1.48453 13.9266 -0.88642 0.622503 9.15822 +8874 6 46.8366 29.0044 2.17213 -21.5573 10.7483 2.0879 +8875 4 46.5703 29.0979 3.11526 14.9241 -10.138 -17.8178 +8876 4 47.6533 28.5191 2.04264 7.39387 -6.09514 13.7966 +8877 6 37.4332 26.1628 25.6457 0.476866 -1.57884 -3.35254 +8878 4 37.1432 25.5044 26.2761 -1.46501 -6.7424 3.65975 +8879 4 36.6379 26.5951 25.3475 -3.92424 6.80267 -0.609098 +8880 6 27.3215 4.19863 19.437 6.03131 -5.89417 1.59018 +8881 4 28.0693 4.5088 18.8685 -19.6633 0.0824503 4.70742 +8882 4 26.4692 4.57526 19.1444 8.48727 3.90116 -6.43998 +8883 6 29.5816 35.1763 32.6702 11.3433 -15.1984 -13.0035 +8884 4 29.498 34.4257 32.0309 -0.34209 19.1564 15.9908 +8885 4 30.487 35.489 32.5363 -2.16348 -1.10322 -0.755163 +8886 6 51.6039 27.3804 34.6228 -16.2846 20.7721 3.47149 +8887 4 51.9118 26.5342 34.8842 8.46829 -31.6815 14.0056 +8888 4 52.043 27.5552 33.7939 4.07896 7.882 -12.2594 +8889 6 26.213 15.718 22.6983 4.45652 -13.2698 4.19624 +8890 4 25.9644 16.5706 22.3629 -2.74203 26.12 0.0562263 +8891 4 25.9462 15.1046 22.0171 -4.99078 -11.3651 -6.14484 +8892 6 36.1284 41.1872 15.4686 -15.9675 5.34592 -0.326298 +8893 4 35.5872 40.4009 15.2728 11.0637 0.363161 -0.898578 +8894 4 37.0593 40.962 15.4319 4.98109 -12.2962 -3.97184 +8895 6 18.4605 8.81439 11.2163 9.85092 25.9028 -2.05591 +8896 4 18.8222 8.21565 11.8732 -2.65799 -9.87079 3.83174 +8897 4 17.6938 8.4288 10.8111 -9.58752 -11.4871 -1.05984 +8898 6 30.2054 21.3176 23.2008 0.0321998 2.06754 0.100272 +8899 4 29.9991 22.2239 22.9456 -2.76699 -3.99559 -1.97847 +8900 4 29.5697 20.7243 22.7648 2.21136 7.68347 0.454199 +8901 6 22.7376 2.20942 34.8415 -7.06988 -25.8748 21.345 +8902 4 22.3263 1.32441 34.7915 6.81547 13.2405 5.99888 +8903 4 22.6443 2.51876 33.959 0.748808 17.6695 -28.972 +8904 6 12.6779 2.74229 12.3423 -3.02369 13.9186 -14.8572 +8905 4 12.6684 3.63953 11.9163 1.20981 -22.4864 12.4813 +8906 4 13.1874 2.20366 11.7175 -0.841633 0.53426 4.77071 +8907 6 24.0891 30.0714 14.5767 2.26717 -13.4561 -11.586 +8908 4 23.8674 30.8343 15.1637 -15.8173 -12.4528 -15.4046 +8909 4 23.3482 29.6562 14.0436 11.1594 27.3113 22.4963 +8910 6 0.0169515 27.9037 22.8558 -22.9231 2.02358 -4.19556 +8911 4 54.5653 28.3586 23.5905 7.88497 -1.22395 1.09473 +8912 4 54.2173 27.7016 22.3138 13.4725 -1.40758 1.11908 +8913 6 12.3768 4.48401 25.8984 -1.01368 1.72138 -1.86924 +8914 4 11.999 5.34556 25.8124 1.61778 23.022 -11.6285 +8915 4 11.6412 4.07623 26.3496 -0.520107 -24.5543 7.98643 +8916 6 50.6552 14.4595 5.90563 -9.7075 2.6569 37.2621 +8917 4 51.421 15.0215 5.71422 1.2699 0.536098 -2.53407 +8918 4 50.4862 14.5526 6.9139 5.60038 -4.97296 -46.1729 +8919 6 52.566 22.8545 20.1304 -1.0263 1.56712 -17.1158 +8920 4 52.8493 23.3468 20.8979 1.30497 -0.175929 17.7779 +8921 4 52.7622 23.494 19.4302 -3.4332 -7.01119 -2.14697 +8922 6 43.5747 16.5432 12.8706 26.1082 -6.15301 -20.1459 +8923 4 44.3581 16.1075 12.4177 -27.2623 16.7463 17.9516 +8924 4 42.8105 16.3628 12.3102 -5.85283 0.59737 -2.51971 +8925 6 15.9643 16.7491 40.5889 4.71604 31.6512 -1.38133 +8926 4 16.4157 17.2981 39.8953 -10.7397 -16.8436 16.4649 +8927 4 15.6568 17.4119 41.253 8.12177 -13.8769 -14.2686 +8928 6 23.4093 18.8548 23.8539 -16.419 -4.21219 2.12821 +8929 4 23.4427 19.3457 24.6888 0.296298 -1.81048 -2.30579 +8930 4 22.5005 18.9913 23.5305 9.65682 -2.29273 2.24785 +8931 6 46.4286 3.27372 31.8783 1.50761 -1.36157 -5.63512 +8932 4 45.559 3.26328 31.468 -2.27736 -0.687336 -10.0334 +8933 4 46.2409 3.35124 32.8099 7.04458 2.11131 4.36323 +8934 6 43.404 41.0501 12.2894 -4.74196 -21.563 6.60959 +8935 4 43.6943 41.7945 12.8025 5.82787 10.392 6.16968 +8936 4 43.4921 41.2918 11.3656 -0.276957 5.00436 -10.4807 +8937 6 7.4944 32.479 29.5886 4.16519 42.7458 -9.72808 +8938 4 8.11522 31.7905 29.7504 15.4265 -22.4366 1.70525 +8939 4 8.06583 33.2868 29.4339 -18.9062 -19.2919 1.43274 +8940 6 4.77786 31.6555 22.5097 8.01353 -0.237295 6.09653 +8941 4 5.36252 32.2279 23.0433 -12.0801 1.27555 -9.50519 +8942 4 4.10079 32.1892 22.0697 5.55495 3.82082 5.5049 +8943 6 48.8707 26.8644 2.67473 3.24755 -50.1854 9.90243 +8944 4 49.7841 26.6767 3.05593 -33.5394 4.93648 -17.7122 +8945 4 48.3402 25.9967 2.74374 27.3415 43.0547 -3.91521 +8946 6 35.3704 23.2724 21.6151 -20.572 -8.60634 18.7236 +8947 4 36.1531 22.7653 21.8467 10.3528 0.763668 -1.9928 +8948 4 35.5272 23.8633 20.8878 14.153 10.3741 -19.8739 +8949 6 9.81162 37.7752 27.3066 -7.93747 -1.88745 -15.4111 +8950 4 9.56608 38.5967 27.7736 11.3364 -13.9943 4.65066 +8951 4 10.53 37.2723 27.7168 -2.00951 8.75096 9.6206 +8952 6 6.95784 10.9804 26.0002 -14.8513 -9.26658 -13.6642 +8953 4 6.43708 10.2284 25.6287 17.7452 16.2397 9.86134 +8954 4 7.32481 10.7062 26.8445 2.87033 -7.35616 11.341 +8955 6 15.9925 34.488 38.9165 -7.91378 13.4212 -4.2482 +8956 4 16.1125 33.5888 38.5756 -0.423195 -0.537141 7.5048 +8957 4 15.8451 34.497 39.8859 4.12272 -10.609 -16.5735 +8958 6 24.136 17.3087 36.1669 -1.30362 -38.1211 0.134245 +8959 4 24.6388 17.5417 36.9612 2.54889 -4.89456 5.81445 +8960 4 24.0565 16.298 36.169 6.29988 31.3296 1.89661 +8961 6 29.9661 19.0481 5.63552 -3.51045 -24.0694 26.081 +8962 4 30.059 18.4844 6.44318 1.40084 7.89656 -22.1005 +8963 4 29.4651 19.7932 5.9612 -6.50009 17.0844 0.645364 +8964 6 41.2323 14.2118 25.8708 0.538972 29.9242 -13.4546 +8965 4 41.1167 15.1135 25.4912 3.21098 -20.1981 4.76589 +8966 4 41.3237 14.3734 26.8138 2.01946 -2.10135 6.77926 +8967 6 30.5977 17.7991 37.3648 -2.09385 13.2702 -7.29075 +8968 4 30.1274 18.3693 36.6865 13.7219 -8.47854 26.2153 +8969 4 30.6897 18.2674 38.2325 -7.09621 1.58925 -18.9017 +8970 6 36.2622 35.7606 28.8616 -21.9344 -15.8478 13.9239 +8971 4 36.666 34.9659 29.2737 0.470987 14.2463 -5.72758 +8972 4 36.9609 36.34 28.5862 17.8584 7.52692 -3.58957 +8973 6 0.186361 37.881 20.3783 -19.4052 1.06805 -13.5296 +8974 4 0.625244 37.258 20.9754 1.43275 1.23053 -1.08677 +8975 4 54.3963 37.4077 20.0073 13.2242 8.68111 6.51083 +8976 6 49.5157 39.5849 25.2719 1.34086 -27.0873 28.6785 +8977 4 49.1738 39.8396 26.1677 9.83442 -4.23573 -27.15 +8978 4 49.8309 38.6394 25.3482 -11.1501 31.2987 0.525887 +8979 6 21.6501 10.2052 29.3652 1.38747 -32.8599 -17.8213 +8980 4 21.4815 11.1062 29.1158 -2.57329 19.5966 11.1399 +8981 4 21.7962 10.0736 30.3036 1.32123 13.0863 10.38 +8982 6 36.4484 30.062 0.133613 20.0221 49.2239 1.07318 +8983 4 36.3691 29.4748 41.3122 -8.72629 -28.1564 -18.1683 +8984 4 36.9877 30.812 41.6437 -16.8233 -22.5363 23.3328 +8985 6 35.2366 23.3806 39.1473 20.2218 -67.2813 -35.6269 +8986 4 34.8925 23.3776 38.2436 -2.85003 -5.00903 7.3464 +8987 4 34.9678 24.1769 39.4749 -24.7984 75.1446 29.9953 +8988 6 25.4958 17.6356 38.7131 -1.05403 5.23051 -13.5311 +8989 4 26.2557 17.1099 38.9745 11.6052 -6.82876 2.03202 +8990 4 25.6896 18.4914 39.1039 0.551448 5.55093 4.31103 +8991 6 32.6851 1.71412 15.3757 -17.1832 -26.0249 32.2484 +8992 4 32.9133 1.90091 16.3255 -0.281287 1.06348 -22.8896 +8993 4 32.1369 0.878474 15.451 14.5551 28.5253 -7.92953 +8994 6 2.74577 26.2334 40.164 -3.83079 -17.2464 -24.8373 +8995 4 2.52975 26.8073 40.8689 -10.0885 25.811 23.4985 +8996 4 3.46379 25.6906 40.4857 13.7859 -11.3271 -3.22577 +8997 6 25.4247 39.5803 6.65235 -3.20662 25.1889 -29.4644 +8998 4 26.0108 39.0547 7.19361 -10.0861 -10.9475 13.3666 +8999 4 24.4797 39.508 6.87242 11.3389 -11.2764 10.0712 +9000 6 3.89558 2.45526 21.1915 20.3615 -74.5786 -16.468 +9001 4 3.45835 1.54866 20.9342 19.9424 46.4596 11.9477 +9002 4 3.20863 3.06758 21.3193 -35.5841 29.5388 2.2294 +9003 6 19.428 35.9937 6.17834 -35.0483 8.79483 10.2733 +9004 4 18.6638 35.8781 6.77432 14.6839 -5.07873 0.0324743 +9005 4 19.0495 36.6291 5.56439 9.71061 8.85688 -10.7695 +9006 6 53.6717 10.8593 34.7958 -7.0633 -31.3632 -8.45381 +9007 4 53.6341 10.4895 35.6991 7.39736 18.8685 -12.2464 +9008 4 53.8829 11.7827 34.7263 4.03482 19.5096 16.0301 +9009 6 51.2684 14.0949 34.672 -8.65676 -1.63762 -26.9588 +9010 4 50.7715 13.5641 33.9816 13.3581 12.906 22.4054 +9011 4 51.0369 13.7812 35.5532 -5.90867 -9.66849 3.74112 +9012 6 14.4369 40.0234 28.032 -17.7583 12.3896 33.8878 +9013 4 13.8707 39.2432 27.9284 6.73847 -3.79593 -5.43806 +9014 4 14.0697 40.4885 28.8439 14.5888 -10.3946 -25.5694 +9015 6 36.0586 40.8581 1.30985 34.3129 5.11816 -1.28261 +9016 4 35.3876 41.022 1.96214 -5.4524 5.11716 12.4526 +9017 4 36.8901 41.3246 1.61712 -30.5352 -10.0787 -2.88322 +9018 6 32.5955 21.8673 9.61487 11.2903 3.47268 22.8686 +9019 4 32.2562 21.1899 9.03409 -3.19899 -6.31213 -16.1683 +9020 4 32.8032 22.6511 9.09762 -2.66985 0.307575 -11.8305 +9021 6 53.7554 11.4583 10.0657 12.5408 -15.0223 -21.3323 +9022 4 54.7025 11.5478 10.261 -4.15933 2.55001 3.12883 +9023 4 53.7605 10.7769 9.36125 -9.51558 7.63224 9.70748 +9024 6 25.4365 2.06658 35.0039 -16.8474 18.4627 -14.151 +9025 4 25.5892 2.94197 34.5728 -1.09755 -16.5277 9.12484 +9026 4 24.4603 2.05675 35.1439 15.8828 -2.54758 -2.86629 +9027 6 38.4258 16.3759 27.0837 10.3035 -3.82582 33.4754 +9028 4 38.4229 16.0362 28.0039 4.2105 -6.34073 -14.2668 +9029 4 38.1536 17.2766 27.2341 -1.96409 14.1736 -9.55492 +9030 6 11.9898 11.8134 38.076 -13.826 -2.82892 7.4824 +9031 4 12.2944 12.4411 38.7385 15.2198 2.85174 -2.31876 +9032 4 11.0532 11.721 38.3132 2.05768 -5.32701 -10.6008 +9033 6 21.1746 40.7334 25.8979 40.4357 -13.6237 -24.6728 +9034 4 20.6698 41.4315 25.4918 -16.6357 14.348 -0.996217 +9035 4 20.789 40.494 26.7242 -19.3448 -1.94923 24.9485 +9036 6 5.46053 31.2633 28.1043 10.2831 7.82506 0.3012 +9037 4 4.85681 31.7249 27.5011 4.53193 2.9664 -2.03256 +9038 4 6.18919 31.875 28.3487 -9.19227 -4.78386 -2.03476 +9039 6 38.5722 10.4288 26.6273 1.75688 -6.42268 2.69181 +9040 4 39.2722 10.957 26.2192 0.13713 -2.38088 1.965 +9041 4 38.9883 9.93745 27.351 -0.726559 6.62326 -4.692 +9042 6 34.5654 22.2334 5.77474 -10.6824 6.04198 20.2303 +9043 4 33.6505 22.4646 6.03122 6.34024 -5.77168 -8.80249 +9044 4 35.1097 22.5906 6.49609 1.67963 -6.25138 -9.01327 +9045 6 19.5088 23.4111 8.91157 10.1707 -16.3121 14.7533 +9046 4 19.7449 23.1021 9.7973 -5.16612 6.6008 -0.0119594 +9047 4 19.9964 22.8054 8.35541 -0.106246 2.40248 -11.9056 +9048 6 19.7526 39.1673 18.9392 3.41392 2.41259 -7.44399 +9049 4 20.3112 38.9942 19.7162 -9.66179 4.90282 -1.08801 +9050 4 18.9888 39.695 19.2431 8.6955 -6.10904 -0.220035 +9051 6 19.0066 16.6479 37.8897 24.9266 -16.0788 2.00499 +9052 4 18.1904 16.5622 37.4269 -20.8911 -0.0800444 -12.5516 +9053 4 18.858 17.3198 38.5387 -2.83386 13.0664 11.2213 +9054 6 46.1457 18.3015 34.4662 -13.7163 3.02283 10.6817 +9055 4 46.1788 17.7584 33.6837 2.50627 -7.36872 -12.652 +9056 4 45.2295 18.6352 34.4793 7.83367 -3.11582 0.242547 +9057 6 37.6724 4.92727 10.6572 20.6306 -0.498941 -29.5329 +9058 4 38.5268 5.23995 10.2493 -20.9001 -6.48587 16.5696 +9059 4 37.1025 4.69637 9.88262 10.9132 7.05613 26.3995 +9060 6 51.9879 36.0003 6.84307 -0.0349375 1.28893 10.7684 +9061 4 52.0937 36.793 6.30051 2.19835 -5.62517 4.5242 +9062 4 52.7425 36.0295 7.48232 -7.26034 2.01661 -20.7899 +9063 6 26.6747 12.3215 0.993928 -15.5873 -26.456 -19.7503 +9064 4 26.4829 12.3908 1.92985 -0.4811 3.80705 11.7504 +9065 4 26.1241 11.5295 0.732228 15.7893 19.669 4.48242 +9066 6 51.344 35.7707 13.5244 -1.45768 15.8539 -2.86245 +9067 4 51.4515 36.3837 12.7824 1.55721 2.40741 1.90229 +9068 4 51.4783 34.9191 13.1366 6.57206 -21.9808 -6.55402 +9069 6 1.98876 3.63996 24.5779 3.53339 50.093 -23.5227 +9070 4 1.66274 3.05681 25.2088 -14.7773 -39.8355 33.4132 +9071 4 1.68527 4.50485 24.9411 8.95614 -12.6616 -11.2736 +9072 6 33.5242 15.2767 16.4494 0.0755523 4.59339 -41.038 +9073 4 33.5553 15.5138 15.4787 -3.36737 -9.15609 28.4742 +9074 4 33.81 16.089 16.8707 2.78154 5.67933 12.8052 +9075 6 10.7376 26.5972 37.3568 -53.543 46.6204 -3.13137 +9076 4 10.2745 27.0143 38.1249 4.48347 -4.84659 -12.5134 +9077 4 11.4659 26.2171 37.7527 59.8403 -33.1666 26.4091 +9078 6 39.618 8.36935 32.0025 -18.1555 9.41152 20.5333 +9079 4 39.1948 8.91554 32.6893 14.8148 -9.04413 -3.7523 +9080 4 39.059 8.55692 31.2545 -3.75745 -0.899113 -17.0741 +9081 6 48.8678 24.2325 11.5968 8.56011 -30.9839 -7.0275 +9082 4 49.2355 23.3258 11.4382 -10.5357 21.2684 5.64902 +9083 4 49.6052 24.6956 12.0119 -1.11745 3.30341 0.0123828 +9084 6 15.7966 8.52145 22.5402 1.04041 9.04678 1.57429 +9085 4 15.9271 8.56462 21.5825 -0.708828 -3.15413 5.43528 +9086 4 15.5351 9.42629 22.7739 -0.982858 -3.13072 -0.606507 +9087 6 16.9647 23.5461 7.94634 -33.4976 4.63454 -7.56842 +9088 4 17.0449 23.8842 7.03772 17.2153 -3.19264 11.7182 +9089 4 17.7681 23.4723 8.45101 25.4501 5.7081 -7.03081 +9090 6 42.4788 26.856 6.32162 3.09129 16.6976 -8.96027 +9091 4 41.8509 27.5547 6.55233 4.05081 -5.7053 1.31186 +9092 4 43.1337 27.3683 5.79469 -5.76138 -9.42264 4.17624 +9093 6 36.7899 4.80361 30.039 -6.11534 9.52442 2.68488 +9094 4 37.0233 4.89717 30.9689 4.03122 4.23205 -0.240484 +9095 4 36.2783 4.00567 29.9694 -7.15291 -10.8132 -0.980928 +9096 6 45.6188 11.6101 3.31184 17.0103 13.4398 12.4748 +9097 4 45.8378 10.6807 3.43524 1.11174 -8.0511 2.33471 +9098 4 46.2756 12.0957 3.86714 -12.3909 -9.3108 -12.4209 +9099 6 24.8953 36.3829 21.2888 -10.2051 -4.79955 -3.81503 +9100 4 24.4947 36.4635 22.1668 10.8854 5.06826 1.45383 +9101 4 25.816 36.6689 21.3407 0.621807 2.11968 6.76072 +9102 6 31.8152 24.7333 2.44905 16.2387 18.0677 -0.666362 +9103 4 31.5926 23.846 2.71622 -2.49338 -12.6998 4.18613 +9104 4 32.794 24.7683 2.43834 -16.3068 -2.39725 -1.0987 +9105 6 24.1315 21.9864 37.2328 -11.9778 41.7246 15.7453 +9106 4 24.1531 22.9879 37.1682 1.73438 -35.6656 2.36813 +9107 4 24.6319 21.6756 36.4808 8.45953 -1.72708 -12.6617 +9108 6 37.1993 11.5451 15.0492 16.5469 7.10484 -0.527568 +9109 4 37.9299 11.7412 15.6355 19.6925 -10.3737 -3.43176 +9110 4 36.5282 11.9944 15.5291 -36.4248 10.8574 4.75341 +9111 6 36.4804 20.3298 41.7865 -14.7619 -38.0306 11.4639 +9112 4 36.2972 19.4996 41.306 -2.7681 3.32899 7.9346 +9113 4 36.9128 20.8369 41.1399 19.1888 26.5648 -23.5244 +9114 6 32.0378 37.9251 32.6621 -20.5074 -27.3147 -8.21436 +9115 4 32.5159 38.6908 32.9558 4.48721 20.2349 -0.22713 +9116 4 31.3298 38.1855 32.0457 8.6638 5.37323 8.26506 +9117 6 12.0353 39.9275 22.5179 -19.9222 21.97 13.043 +9118 4 12.3148 40.8142 22.1582 -9.65836 -22.9721 12.3921 +9119 4 11.2968 40.0749 23.1753 26.4497 -1.81786 -22.4595 +9120 6 26.3421 1.33641 19.2861 18.8224 -12.0939 15.9617 +9121 4 26.8564 0.711595 19.8557 -14.3211 16.2919 -14.6989 +9122 4 26.7977 2.18849 19.3545 -2.53714 -0.144297 -3.51109 +9123 6 5.91333 14.3058 5.68279 5.58536 -17.6781 -26.1831 +9124 4 6.35226 14.1008 4.80839 -10.2521 5.5819 21.3359 +9125 4 5.1498 13.7016 5.72209 7.95548 1.62414 0.442017 +9126 6 13.3681 23.0924 19.1542 -7.87238 10.4677 13.234 +9127 4 14.1204 22.8148 18.6592 15.6827 -8.39443 -13.4152 +9128 4 13.7622 23.5769 19.9007 -5.90355 -3.89356 -3.96922 +9129 6 23.3981 15.0775 9.7431 -16.2896 3.15659 0.0853289 +9130 4 22.5416 14.6758 9.94236 4.38356 -3.66538 1.71341 +9131 4 23.1926 15.7004 9.03099 5.43777 4.93098 -2.67512 +9132 6 49.5886 13.8369 18.4468 -1.57371 0.160736 10.1606 +9133 4 48.8725 13.4353 17.9701 -17.3578 -11.6866 0.338485 +9134 4 50.0711 14.2256 17.7358 20.2332 17.1818 -14.445 +9135 6 41.7455 5.66741 41.8995 19.0031 1.14603 7.86728 +9136 4 42.5946 5.93333 0.438032 -19.5636 -6.95293 -12.6597 +9137 4 41.9891 5.05837 41.1762 -2.65724 5.24908 4.18535 +9138 6 17.2511 35.5417 2.55548 5.2045 0.397579 1.12894 +9139 4 18.2067 35.619 2.48098 6.39755 9.05508 3.07921 +9140 4 17.0886 34.6316 2.34229 -4.27489 -11.2961 -3.02567 +9141 6 49.7041 19.8589 40.2412 43.8428 -27.8149 3.09893 +9142 4 49.318 19.0163 40.5437 -5.31641 8.5833 -2.14336 +9143 4 50.6864 19.6533 40.2493 -27.6084 12.6334 -3.24012 +9144 6 38.3071 5.82731 32.0534 -20.9946 -3.84451 12.3853 +9145 4 37.8352 6.48986 32.6009 6.6943 -7.79079 -6.23381 +9146 4 39.2094 6.1245 32.003 13.4939 6.60324 0.292563 +9147 6 16.2694 6.84865 34.0054 -5.49782 1.82896 8.85162 +9148 4 16.5828 6.71308 33.1028 9.77351 -3.29618 -0.21352 +9149 4 16.9894 6.61948 34.6288 -2.86373 0.259786 -9.19674 +9150 6 33.6805 18.2019 10.4544 40.2358 -26.4835 -11.4715 +9151 4 34.2537 18.8203 9.96489 -9.74865 -7.15313 7.53482 +9152 4 34.2179 17.3378 10.5117 -27.819 38.8859 -1.78852 +9153 6 38.8962 33.7675 36.7566 23.6769 3.34821 -39.6603 +9154 4 38.383 33.5793 35.9171 9.63189 4.7017 21.543 +9155 4 39.855 33.8637 36.4612 -29.1237 -5.01255 9.39617 +9156 6 45.367 13.0954 20.2202 -17.4715 7.54819 27.7127 +9157 4 45.262 12.6289 19.4029 4.78427 -8.6457 -19.3619 +9158 4 44.4728 13.0498 20.6095 8.33403 2.77458 -3.46579 +9159 6 36.394 32.2025 8.83838 -5.39961 -0.779561 10.8196 +9160 4 36.3766 31.4559 9.45045 4.37642 -0.919546 -0.394048 +9161 4 35.9671 32.9207 9.33542 2.20851 -0.984819 -7.57369 +9162 6 7.93081 27.8143 6.16526 -1.31132 8.47671 -18.7581 +9163 4 8.2701 27.2941 6.88743 5.87236 -5.84072 6.56369 +9164 4 8.18271 28.7096 6.41539 -7.71007 1.94397 -1.55613 +9165 6 14.2797 4.87717 33.6823 -38.1616 11.9775 -32.0892 +9166 4 13.6477 5.2447 32.9846 23.9092 -16.4836 27.177 +9167 4 14.8408 5.63056 33.8658 12.4601 7.15131 6.13949 +9168 6 12.2578 8.65243 9.85848 -4.82715 -2.24662 -5.48477 +9169 4 12.6456 8.73928 10.7118 23.7259 9.48722 19.5525 +9170 4 11.4378 8.2214 10.089 -13.622 -8.47682 -13.9839 +9171 6 29.7261 31.9842 8.54243 -17.2145 25.3825 -18.7463 +9172 4 30.1804 31.833 9.34913 11.7892 -12.8324 21.9258 +9173 4 29.6399 31.1708 8.03663 5.85846 -6.51984 4.51241 +9174 6 22.3891 10.8785 21.4662 8.73739 -5.18702 6.55753 +9175 4 21.8037 11.1386 20.7714 -14.2177 0.338512 -24.4291 +9176 4 22.2091 11.5521 22.1168 2.36988 5.22793 14.1218 +9177 6 54.1797 27.5396 12.9955 26.3988 -18.3584 17.6139 +9178 4 0.160041 27.5787 13.0909 -6.71045 -5.06664 4.99497 +9179 4 53.9798 28.2721 12.4475 -15.7222 27.4826 -22.0497 +9180 6 7.71973 13.812 20.0407 -34.9077 17.0186 -30.9147 +9181 4 8.32362 14.1503 20.6766 20.1403 8.526 22.156 +9182 4 7.35968 14.6399 19.6101 8.73645 -26.5601 8.16532 +9183 6 19.7932 0.841243 24.7869 -1.21084 18.2021 12.2367 +9184 4 19.1669 1.06895 25.5104 7.86649 -0.445713 -11.3386 +9185 4 20.4073 1.61074 24.7031 -15.4775 -18.2332 3.4978 +9186 6 3.01312 10.0986 2.94829 -27.2997 12.089 -8.88269 +9187 4 2.52802 10.9508 2.83041 12.1807 -20.5661 3.67701 +9188 4 3.91304 10.3154 3.17839 17.025 6.36995 4.07131 +9189 6 15.8857 13.0124 24.0049 15.5529 -4.67501 -5.43243 +9190 4 15.0856 13.5308 24.0834 -5.13718 6.9751 3.63726 +9191 4 16.3233 13.139 24.8614 0.105722 -2.17465 -3.852 +9192 6 17.0852 4.33969 26.9167 21.5143 -4.09641 1.48348 +9193 4 16.9912 4.27513 25.9666 -0.355278 1.74978 -10.9716 +9194 4 18.0601 4.31538 27.0472 -16.9044 3.21714 1.83131 +9195 6 33.6168 39.4091 10.6433 -2.74936 14.5855 -32.8438 +9196 4 33.9454 38.5625 10.8616 8.60753 -33.4012 17.9817 +9197 4 33.8375 39.4354 9.68976 -8.01757 16.2593 11.171 +9198 6 36.2326 1.10755 13.0941 -10.1125 -3.31802 -5.56412 +9199 4 35.6506 0.392496 13.3579 -10.7819 -8.26966 -9.36682 +9200 4 36.7599 1.20112 13.8707 17.1874 9.72194 12.3054 +9201 6 40.862 19.2925 5.11158 -0.402197 -15.9333 44.5432 +9202 4 40.3871 19.4968 4.34679 -15.032 12.6888 -52.1674 +9203 4 40.1189 19.1611 5.72143 13.4548 0.976419 10.4775 +9204 6 2.35452 37.5497 10.1778 32.5589 0.132829 19.8916 +9205 4 3.04634 37.0953 10.7141 -10.4583 9.64478 -9.40166 +9206 4 1.85979 36.8581 9.75685 -15.4906 -16.9123 -13.0897 +9207 6 8.10293 29.0334 15.8847 29.3895 -23.7333 0.542295 +9208 4 9.03551 28.6824 15.7668 -29.6945 17.5799 0.572456 +9209 4 8.18484 29.8326 16.4072 3.85606 5.10463 3.42896 +9210 6 47.3132 26.514 12.5427 4.56821 28.1849 -37.0073 +9211 4 47.5111 27.2634 11.8891 -8.56493 -28.9528 31.2783 +9212 4 47.3519 25.7475 11.9556 -1.34676 -3.33794 4.54904 +9213 6 33.5886 17.4994 0.666432 -7.15301 -2.01744 8.51284 +9214 4 32.6196 17.5968 0.930917 31.8637 -19.8727 -7.43903 +9215 4 33.9404 16.5735 0.747207 -21.2256 15.6146 2.50609 +9216 6 38.9757 15.6004 36.3686 4.31005 -11.6982 -11.4703 +9217 4 39.1719 14.652 36.4294 -3.02079 4.3409 1.02949 +9218 4 39.3764 15.8813 35.5317 -1.53099 5.14915 -0.246696 +9219 6 34.8198 34.351 9.37266 2.46578 -22.7668 -16.8875 +9220 4 35.3506 35.0289 8.96724 14.9634 11.0695 -15.2613 +9221 4 34.4558 34.8191 10.0913 -19.5236 18.4179 34.8179 +9222 6 44.9681 2.58102 14.7874 21.8703 21.498 2.75759 +9223 4 44.0383 2.44896 14.9383 -16.9502 -5.72583 1.77575 +9224 4 45.1679 3.47323 15.1264 -3.49788 -5.23458 -3.46791 +9225 6 42.6138 38.2902 19.8325 18.6047 12.1973 -29.2276 +9226 4 42.7029 39.1598 19.3445 -0.0117609 -27.8329 13.7468 +9227 4 43.0921 37.6383 19.2425 -13.1736 20.1758 17.0781 +9228 6 18.6869 26.7647 30.2619 -33.6624 -6.012 -17.6355 +9229 4 18.1258 26.7596 29.445 14.3051 -0.674317 21.614 +9230 4 19.5687 26.9499 29.9621 19.5047 4.84041 -5.57389 +9231 6 38.8661 37.7421 16.4836 -9.78438 -6.51051 7.80135 +9232 4 38.7478 36.8102 16.2377 -7.01003 6.44463 1.75037 +9233 4 39.8105 37.8446 16.5724 18.1337 5.4462 2.51551 +9234 6 49.3017 9.82081 12.5377 12.9664 18.8416 30.0962 +9235 4 48.8085 9.39111 11.8826 -17.6666 -23.7062 -38.8329 +9236 4 48.5984 10.2345 13.0427 4.42646 9.01279 7.79627 +9237 6 43.2246 7.36268 19.8264 -1.99344 11.167 24.993 +9238 4 42.5572 7.81175 20.4051 12.7818 -10.9207 -14.0727 +9239 4 44.1025 7.51179 20.2375 -5.96789 -3.6213 -7.06723 +9240 6 36.3461 38.714 4.42821 -2.77728 9.11116 8.98737 +9241 4 36.8002 39.5234 4.70824 5.05063 -6.10698 -1.49424 +9242 4 35.4394 38.9016 4.68929 -3.84434 -7.68842 -3.54296 +9243 6 27.8 17.802 15.105 0.992317 -7.44098 -8.78046 +9244 4 27.5393 16.935 14.729 3.58787 16.6938 2.50389 +9245 4 27.8517 17.6781 16.0585 0.147204 -0.130556 3.13955 +9246 6 18.0837 3.77506 37.3201 -10.3169 -12.5791 -10.2966 +9247 4 18.6663 3.07474 37.0146 -2.03685 -5.25132 -4.70316 +9248 4 18.6637 4.19691 37.9324 10.4473 20.1285 21.3871 +9249 6 7.71395 11.575 6.52222 6.59834 -21.2687 20.1659 +9250 4 7.75955 12.4254 6.93969 -0.705235 13.257 9.50392 +9251 4 7.66936 11.739 5.5978 -3.42683 1.36071 -31.338 +9252 6 31.4909 14.3449 18.0451 -1.46982 -12.276 17.176 +9253 4 32.1287 14.6507 17.397 7.38292 5.65775 -7.44504 +9254 4 32.0331 13.8785 18.7146 -6.90734 4.25576 -5.30331 +9255 6 50.3346 30.4143 8.91505 10.1635 2.25064 -1.90936 +9256 4 49.6557 30.853 8.39615 -4.47176 4.28708 -1.87566 +9257 4 50.0231 29.531 9.11356 -2.73977 -1.84009 2.34474 +9258 6 42.1686 10.1057 12.759 16.2008 2.03437 -4.20809 +9259 4 41.2649 9.83209 12.6487 -17.4225 -8.81494 -4.74081 +9260 4 42.1292 10.8861 13.3105 -1.28453 5.18814 5.66853 +9261 6 37.773 3.09539 32.5582 -5.24906 4.78867 -2.39206 +9262 4 38.0736 3.99724 32.5969 21.7942 11.3719 -4.3192 +9263 4 36.8519 3.25822 32.7463 -19.4678 -11.9252 3.55114 +9264 6 35.7586 13.1005 19.2721 9.99017 -22.7528 0.0781354 +9265 4 36.1308 13.8223 19.7887 2.26592 2.2719 5.61144 +9266 4 36.2509 12.2915 19.5517 -9.66412 15.3645 -2.5809 +9267 6 45.5318 4.12684 21.4944 7.1153 -16.224 0.922187 +9268 4 45.5588 4.23252 20.5315 -1.8039 6.94223 3.67507 +9269 4 45.7548 3.18328 21.6122 -5.15542 13.2346 -0.821742 +9270 6 16.876 1.8608 31.4782 -3.84426 -17.9183 -35.0426 +9271 4 16.0621 2.17388 31.0004 15.6258 0.929179 27.3362 +9272 4 17.1381 2.25043 32.3174 -12.6393 14.1325 4.42374 +9273 6 14.0947 4.88307 23.5769 -10.6061 -28.6131 16.0669 +9274 4 13.8059 5.76888 23.7237 -2.25817 32.588 -6.82267 +9275 4 13.6039 4.42137 24.2892 9.04813 -2.88937 -11.9208 +9276 6 38.3208 33.7635 12.3625 -16.3318 -7.70706 -26.0192 +9277 4 38.1373 32.9408 11.8506 0.297782 14.7405 12.2413 +9278 4 39.1486 33.6221 12.8093 16.0136 -1.39994 11.7584 +9279 6 35.6849 3.05753 37.6719 3.72695 1.1389 -16.7638 +9280 4 35.1101 2.5063 38.212 -4.0587 0.687226 6.19097 +9281 4 35.8854 3.87289 38.1447 -1.86413 5.08658 8.8135 +9282 6 31.3385 37.395 35.3723 -12.2239 -8.91609 34.0312 +9283 4 32.2231 37.7249 35.5382 9.93962 6.70229 -3.55138 +9284 4 31.225 37.4524 34.4409 4.86335 0.993516 -31.3389 +9285 6 52.0614 11.7324 14.0182 20.1458 -4.7001 -39.6215 +9286 4 52.0268 11.0667 13.2735 0.495691 14.4049 24.809 +9287 4 52.7095 12.4171 13.7023 -24.8081 -17.2766 13.6147 +9288 6 26.3478 3.42613 41.0189 1.80794 1.58056 -19.374 +9289 4 25.6151 4.01507 40.9203 -25.7718 5.99951 16.8165 +9290 4 26.7914 3.68675 40.2055 22.5797 -12.3384 -0.204994 +9291 6 24.3802 34.9453 11.1613 28.8325 38.7039 -6.19962 +9292 4 24.3515 34.6784 12.0652 -4.50215 -14.1529 28.2178 +9293 4 23.9023 34.3202 10.6558 -20.492 -31.6724 -14.1682 +9294 6 32.0094 7.59293 31.2147 -3.26399 8.81733 5.62682 +9295 4 32.0976 7.47613 30.2777 2.1706 -0.778595 -17.1478 +9296 4 31.5266 8.43606 31.2858 0.565291 -7.84955 4.65821 +9297 6 28.7282 2.60805 0.424377 -15.1279 1.50585 -5.39222 +9298 4 29.2952 2.36387 41.5859 -5.33248 3.35197 5.42737 +9299 4 27.7901 2.65331 0.119401 23.4632 0.0509354 2.06419 +9300 6 42.125 19.2126 9.86039 10.7783 -7.26578 33.4177 +9301 4 42.6695 19.2101 10.7019 -20.1092 0.869002 -30.5597 +9302 4 41.4363 18.5278 9.96356 3.48727 6.10561 -4.25932 +9303 6 33.0194 27.0842 8.32851 16.6372 -6.55357 -10.7525 +9304 4 33.8911 27.0001 7.90493 -7.38323 -0.765342 -2.5624 +9305 4 33.2437 27.3744 9.20899 -0.425855 7.33259 11.2137 +9306 6 4.16433 8.30018 19.1575 16.0783 -2.51395 5.95143 +9307 4 4.71165 7.98099 18.3991 -19.3854 5.29846 8.38252 +9308 4 3.22273 8.32359 18.9288 3.05712 -5.28108 -12.2975 +9309 6 20.7745 29.1912 37.0609 -25.9123 -20.3491 -5.83769 +9310 4 21.0713 28.277 37.0594 -15.1664 -12.7508 0.5123 +9311 4 21.6013 29.5933 37.1743 32.957 35.4267 8.73191 +9312 6 13.1089 4.99809 10.9103 2.80775 13.1965 -7.17841 +9313 4 13.4591 5.85092 11.2415 -2.5949 -14.1267 -1.88178 +9314 4 12.7051 5.16456 10.0462 -1.2434 3.82389 2.90473 +9315 6 37.5087 18.1031 32.5343 20.0502 31.699 14.1692 +9316 4 38.1018 18.8164 32.1735 -18.2411 -21.7333 4.56216 +9317 4 37.2041 18.4813 33.3903 1.90105 -7.17599 -12.7275 +9318 6 17.7655 33.2839 30.7231 12.9967 19.9173 -17.9311 +9319 4 17.8488 34.0437 30.1253 -3.68331 -4.50715 1.49576 +9320 4 18.5638 33.345 31.2563 4.57995 -0.934488 4.72964 +9321 6 23.1969 32.7832 9.90135 2.14033 10.4984 -5.43395 +9322 4 23.4737 31.9362 10.2634 3.28964 -4.66398 1.33779 +9323 4 22.2469 32.7196 9.72631 0.753558 0.42269 -0.434072 +9324 6 14.8911 9.35828 34.246 -8.54616 0.784134 0.501674 +9325 4 15.4672 8.59016 34.1372 5.2294 -0.0873347 -3.8795 +9326 4 15.23 10.0905 33.7027 2.53244 -1.05206 0.202563 +9327 6 31.1203 39.3599 38.5719 4.30147 -17.578 8.21172 +9328 4 31.5941 38.6377 39.0527 -10.1026 17.4492 -9.05875 +9329 4 30.4019 38.9077 38.1077 1.84332 2.82409 1.03593 +9330 6 5.29005 34.4279 28.2716 -0.764315 -10.945 -9.90403 +9331 4 5.24266 35.3772 28.447 -0.427568 -2.02335 -2.15628 +9332 4 5.18384 34.3192 27.3143 2.05225 4.04935 9.99949 +9333 6 30.3216 21.6974 14.1256 3.24994 1.03129 -0.468005 +9334 4 30.4656 20.7696 14.235 0.884625 -14.9253 16.053 +9335 4 30.3519 21.7638 13.1772 -0.963709 16.3006 -15.7103 +9336 6 23.8542 39.0018 28.2919 38.6077 23.8437 -8.99828 +9337 4 23.8505 39.6937 27.6143 9.44649 3.56781 3.51793 +9338 4 23.0185 38.6309 28.1896 -50.029 -28.3524 0.952356 +9339 6 9.61332 13.5451 16.4567 13.7131 10.5156 -25.323 +9340 4 8.77595 13.0917 16.3907 -9.93448 -5.52821 8.41851 +9341 4 9.74204 13.8378 15.5322 5.69689 -3.544 12.5309 +9342 6 25.9753 6.18174 15.7989 23.4837 -9.67411 23.9067 +9343 4 26.0218 6.10484 14.8454 5.11216 -1.95092 -7.71856 +9344 4 26.7445 5.66727 16.1761 -27.6477 18.1551 -17.3833 +9345 6 15.9921 33.6419 22.5616 2.25497 8.86036 -26.9911 +9346 4 16.0049 34.0594 21.6804 -4.22455 0.568633 15.0409 +9347 4 16.1032 32.7157 22.281 -1.05219 8.42244 16.6761 +9348 6 40.6812 13.5416 12.1266 -4.5396 -12.3661 6.74099 +9349 4 40.4134 12.947 11.4149 -4.75912 -2.4644 -8.17888 +9350 4 41.058 12.9332 12.7776 -0.386087 8.79442 1.8157 +9351 6 35.5875 40.2809 31.6993 12.2791 -13.6127 -29.8257 +9352 4 35.948 40.913 31.0681 -4.17713 12.2213 7.17402 +9353 4 35.6271 39.4709 31.1475 -9.59473 3.36029 20.1077 +9354 6 19.3493 17.5927 17.849 24.123 48.8902 3.26857 +9355 4 19.9577 18.423 17.9915 -34.5112 -38.8316 -9.06029 +9356 4 18.6928 17.806 17.1645 6.15508 1.01267 5.31501 +9357 6 7.96541 28.082 10.7737 20.0283 17.3944 8.50509 +9358 4 8.43659 28.8341 11.2297 -13.1431 -15.7733 -11.3814 +9359 4 7.20109 28.4458 10.3015 -0.215648 4.06143 0.688545 +9360 6 32.1489 39.5869 16.6475 -7.37335 1.81146 -4.92627 +9361 4 31.705 40.4043 16.3332 3.90743 -15.5774 4.53996 +9362 4 31.4977 38.8659 16.5723 3.01217 10.596 3.08762 +9363 6 35.8095 2.63602 18.127 2.07542 -14.8225 4.13142 +9364 4 34.8947 2.32962 18.1713 7.15775 -3.6283 3.09768 +9365 4 35.7135 3.4873 17.7367 2.81673 20.5762 -11.5045 +9366 6 14.9588 39.9585 36.8943 -2.86001 -28.3727 24.0409 +9367 4 15.4545 39.4909 36.2335 10.0689 -8.68258 -13.459 +9368 4 15.0094 40.8569 36.655 2.72867 44.443 -9.08423 +9369 6 18.3115 32.3916 11.4639 8.59274 12.4423 14.7113 +9370 4 18.6438 32.5881 12.3772 -9.2478 -5.5834 -23.9484 +9371 4 17.8762 33.212 11.1576 6.35145 -13.5457 0.164794 +9372 6 14.605 10.3819 4.99774 5.57597 -6.68493 12.6773 +9373 4 13.677 10.4388 4.75284 -6.10435 1.24571 -3.75468 +9374 4 14.6185 10.047 5.91478 4.2493 4.0336 -10.9734 +9375 6 2.02851 14.3408 39.1627 -4.03313 12.5981 -1.48522 +9376 4 2.74992 15.009 39.2086 -14.5088 -8.45155 5.07373 +9377 4 1.21458 14.679 39.6124 19.1623 -3.42757 -8.41789 +9378 6 7.58709 14.1522 32.4651 10.4977 19.6861 -0.504887 +9379 4 6.93593 13.6605 32.9674 -3.57672 2.30039 3.8359 +9380 4 7.5987 15.0834 32.797 -1.90079 -22.9019 -5.87851 +9381 6 6.15309 23.123 37.664 -26.7168 -14.8188 -11.2926 +9382 4 6.52639 23.9838 37.7378 17.5333 20.6862 9.20416 +9383 4 5.45539 23.2608 36.9958 8.40974 -10.7335 8.81374 +9384 6 37.3009 22.5422 4.44282 21.6187 66.9857 0.670839 +9385 4 36.5208 22.1217 4.15693 -30.5217 -23.5005 -12.8181 +9386 4 37.1232 23.5227 4.23696 10.5274 -41.8214 11.62 +9387 6 47.1349 31.0113 5.88613 -14.3653 5.64202 -58.02 +9388 4 46.9542 30.9019 6.7933 -9.29323 -2.10558 39.1512 +9389 4 46.2627 31.2059 5.44524 20.5013 -7.22248 10.5418 +9390 6 54.8094 25.5909 34.9286 -5.37395 41.5808 12.672 +9391 4 54.0266 25.5089 35.4943 -0.981006 -11.4098 -6.26775 +9392 4 0.0616925 26.543 35.1263 -1.5494 -32.4448 -11.2369 +9393 6 37.1551 2.08197 4.79239 -12.5712 23.0197 -22.5278 +9394 4 36.5844 2.86136 4.61445 9.59981 -14.8952 -2.62483 +9395 4 37.0798 1.96202 5.72873 2.5296 -7.23911 19.6989 +9396 6 22.5239 28.6012 8.91155 -7.98869 19.6075 21.4366 +9397 4 22.8946 28.4124 9.79991 -0.853296 -5.89568 -17.4096 +9398 4 22.801 27.9767 8.25343 10.1708 -14.6558 -3.7409 +9399 6 8.64208 27.1509 24.5664 -38.2161 25.5543 4.78276 +9400 4 7.71753 26.8887 24.5582 -5.16372 11.0804 -0.386298 +9401 4 9.04357 26.3309 24.4724 40.7169 -47.477 -5.23592 +9402 6 1.14997 23.727 2.4309 6.46058 8.65979 -14.8341 +9403 4 1.18232 23.9936 1.48373 -6.63581 -4.99587 16.5657 +9404 4 0.310199 23.2733 2.54924 -0.981545 -0.950126 -1.89037 +9405 6 54.3702 30.2259 27.0243 -0.035121 6.58363 -4.50453 +9406 4 54.2615 29.4654 26.4339 1.23903 8.74071 -4.24792 +9407 4 54.6064 30.9974 26.4582 -3.83852 -12.4126 5.30421 +9408 6 0.386829 8.42023 23.9938 5.00922 -16.8445 -6.80376 +9409 4 1.36083 8.4508 24.0758 -8.17173 1.21512 3.08891 +9410 4 54.9524 8.88826 24.7258 9.13745 3.54566 6.13736 +9411 6 16.8971 28.5839 33.3722 23.8511 -30.9569 -4.46587 +9412 4 17.442 28.7831 34.1436 -6.82268 9.96305 3.46007 +9413 4 17.4403 27.8723 32.949 -23.4552 19.8179 6.40974 +9414 6 33.6969 30.8931 0.141175 14.1795 0.777253 -0.635822 +9415 4 34.6278 30.5945 0.162696 -6.8513 6.78484 1.91826 +9416 4 33.3211 30.3583 41.3463 -2.66034 -4.05802 -0.0970656 +9417 6 16.2525 21.5202 34.1552 3.2099 -15.0674 -0.387853 +9418 4 16.0099 20.7546 33.5903 4.90739 13.2878 5.87792 +9419 4 16.6977 21.1376 34.9376 -8.96682 7.2262 -10.6242 +9420 6 0.22977 17.7868 35.7492 -9.57638 -14.7124 1.37696 +9421 4 54.2434 17.9569 35.6827 28.6901 -4.22084 5.11773 +9422 4 0.351694 16.93 36.209 -4.1051 13.1178 -5.65765 +9423 6 16.8289 12.2962 0.019427 11.8958 12.8939 11.6481 +9424 4 17.3016 12.8498 0.703368 -12.3262 -21.137 -14.7379 +9425 4 16.4403 11.4936 0.411486 1.39397 8.07719 2.11333 +9426 6 8.24246 9.54397 36.2629 -25.8472 21.2414 2.40819 +9427 4 7.81464 8.9356 36.8788 1.26461 -2.06425 2.56422 +9428 4 7.48979 10.0869 35.9067 16.4576 -8.29365 1.86334 +9429 6 48.5761 26.718 39.8382 -16.8767 -13.2223 25.9758 +9430 4 48.2189 26.9037 38.9774 0.202946 6.43929 -15.4249 +9431 4 49.4865 26.9849 39.8847 17.129 6.93076 -9.10183 +9432 6 35.4777 1.07865 23.1156 20.3084 9.46551 28.8556 +9433 4 36.0215 1.72656 22.6213 -7.75205 -10.5654 8.45632 +9434 4 35.804 1.12911 24.09 -10.3378 -1.68949 -45.1242 +9435 6 20.2777 30.6326 19.3782 17.168 -16.4055 9.77372 +9436 4 20.2499 31.0311 20.2788 1.56461 -6.55175 -10.0354 +9437 4 20.938 29.881 19.3855 -20.6701 22.3694 2.2449 +9438 6 44.3702 15.9458 1.58361 10.9348 22.193 31.2112 +9439 4 44.4077 15.6379 2.51116 -1.71559 -1.42871 -18.164 +9440 4 44.6431 16.8967 1.66823 -9.97295 -22.8516 -13.6111 +9441 6 53.8845 34.4651 10.6068 -24.0145 7.95167 -19.3224 +9442 4 54.4361 34.2696 11.3314 22.7066 -9.19703 33.7305 +9443 4 54.2985 35.2035 10.1555 0.2437 -1.83103 1.50375 +9444 6 46.1364 32.8471 33.519 4.96533 -12.2334 2.48444 +9445 4 45.9404 33.6629 33.0556 -3.66306 8.73713 -2.86335 +9446 4 47.0477 32.6179 33.2654 -4.26196 1.19291 1.09329 +9447 6 42.1324 21.9098 24.2239 34.4777 -24.9191 34.4505 +9448 4 43.0412 21.5159 24.3646 -28.4667 14.3091 -11.1056 +9449 4 41.7437 21.6811 25.0949 -3.80951 9.2794 -19.6729 +9450 6 8.14185 3.89847 11.6387 2.30661 -15.3192 6.95264 +9451 4 7.35197 4.1174 12.1322 -8.99547 12.8437 -2.29886 +9452 4 8.35392 3.05748 12.0535 10.9023 -1.5691 -3.31016 +9453 6 19.6413 41.6808 9.8267 1.07442 6.29255 0.337359 +9454 4 18.9204 41.094 9.57509 0.414049 2.67892 1.92063 +9455 4 19.352 0.205183 10.6506 0.427822 -12.2572 -10.0953 +9456 6 42.3157 8.41085 31.6785 13.3628 11.5473 -7.23952 +9457 4 41.3969 8.42848 31.9417 -9.73605 -1.80426 0.915182 +9458 4 42.5534 9.35818 31.5624 -0.333442 -16.319 1.99913 +9459 6 26.911 16.154 25.3637 -0.10907 13.2502 -20.6653 +9460 4 26.7939 15.8861 24.4207 -0.565005 2.37017 21.4763 +9461 4 26.6835 15.4121 25.9182 -3.52016 -12.4926 6.14171 +9462 6 48.2345 6.48613 12.6212 -1.55264 -8.09911 -9.8466 +9463 4 48.9652 6.31914 12.0011 -5.93235 3.28214 2.19301 +9464 4 47.4516 6.10442 12.1764 7.36669 2.93589 5.65527 +9465 6 53.4556 41.5274 30.6561 0.928349 -3.66285 -10.4005 +9466 4 53.9738 41.8466 29.9077 -1.68735 -3.84443 -4.80087 +9467 4 53.7246 0.16796 31.3785 5.2081 5.34012 15.7103 +9468 6 47.0719 22.4215 31.8177 3.79963 28.0651 -15.4962 +9469 4 47.8542 22.5824 31.2379 -15.4047 -7.22606 14.7582 +9470 4 46.5391 23.2393 31.6689 5.43499 -22.2824 10.2038 +9471 6 19.5241 5.44646 15.2431 57.7261 9.00726 -25.1025 +9472 4 19.973 4.5781 15.2547 -6.4602 7.66804 1.10752 +9473 4 18.6769 5.33307 15.596 -47.9766 -8.78418 19.1468 +9474 6 14.6808 30.2445 33.392 16.954 11.9814 -17.0239 +9475 4 15.1668 30.8865 32.8123 -10.4914 -16.0898 10.6301 +9476 4 15.2553 29.4559 33.3904 -4.22445 9.80292 -0.52553 +9477 6 28.4427 24.2289 10.4187 -0.774793 -27.6212 -36.8967 +9478 4 29.277 24.4414 10.8128 10.21 14.4589 20.8069 +9479 4 27.7162 24.5027 10.9517 -9.91177 12.6254 22.5109 +9480 6 5.25429 14.4357 24.4952 18.8694 8.38265 -3.5804 +9481 4 4.38598 14.1455 24.6681 -43.369 -9.18674 12.4123 +9482 4 5.45154 13.9758 23.6794 9.52503 -2.95522 -10.1363 +9483 6 26.3476 19.2988 19.1857 11.4015 -18.2951 -12.5804 +9484 4 26.5417 20.1869 19.4853 3.52858 10.6793 1.31948 +9485 4 27.146 18.9308 18.7141 -21.2465 13.7562 17.259 +9486 6 28.5834 7.44603 13.1845 8.68409 29.8386 11.3246 +9487 4 28.3961 6.55455 12.9442 -2.45324 -19.0833 -9.20205 +9488 4 29.0571 7.89665 12.4686 -5.14786 -6.54739 -1.73865 +9489 6 5.35742 27.1473 37.0464 13.0843 -4.728 13.8292 +9490 4 6.09472 26.8663 37.6487 -17.7636 2.66278 -18.049 +9491 4 5.49884 28.0724 36.7882 1.93418 -3.90879 0.386893 +9492 6 53.1466 13.4128 16.1104 33.6732 -23.607 0.886679 +9493 4 54.0532 13.0537 15.8959 -24.4904 18.1541 2.55443 +9494 4 52.6056 12.6236 16.2807 -0.490038 10.6025 -2.0621 +9495 6 45.4595 1.03561 24.6152 0.883869 7.22473 8.82703 +9496 4 44.8005 0.912307 23.9218 -0.0838502 -1.3445 -1.23214 +9497 4 44.9845 0.757767 25.4168 6.19386 0.932014 -5.94613 +9498 6 50.1542 2.38642 13.9319 -2.4774 12.931 -1.3926 +9499 4 50.7815 2.76975 13.3044 0.014285 -4.08681 1.38242 +9500 4 49.5062 3.09016 14.0651 -1.63783 -0.639647 1.83323 +9501 6 19.5885 31.0175 39.1657 -10.9837 -21.6636 -18.6241 +9502 4 19.8079 30.3148 38.4832 -5.60324 21.7545 20.6111 +9503 4 18.6148 30.9453 39.3442 26.0441 2.6939 -5.02925 +9504 6 19.2491 14.7106 10.8907 20.9533 -11.5465 -13.087 +9505 4 20.0062 14.1954 10.4207 -44.2836 18.7066 28.5885 +9506 4 18.7045 14.0688 11.3882 14.1221 2.37282 -8.47947 +9507 6 4.44986 39.5549 20.1348 -7.46971 20.8744 22.4052 +9508 4 3.99116 40.4291 20.2667 12.3042 -22.0468 -4.08326 +9509 4 4.78876 39.261 21.0122 -11.398 5.88582 -21.7205 +9510 6 29.0264 13.3645 23.891 3.80322 20.0192 21.3715 +9511 4 28.7263 12.4558 23.8574 1.87437 -3.97007 -2.19356 +9512 4 28.9189 13.5991 24.8488 7.01015 0.856522 -27.3099 +9513 6 17.0674 2.76528 17.6511 13.6679 -9.88609 -24.0062 +9514 4 16.9089 3.43106 16.9566 -0.337692 -4.66999 2.92783 +9515 4 17.7694 2.16287 17.2836 -16.7881 13.7863 9.44417 +9516 6 43.472 18.0456 17.7207 2.90116 -6.00314 -10.3001 +9517 4 43.5328 17.0661 17.6262 0.602958 19.7978 9.46789 +9518 4 43.5843 18.2505 18.6627 0.176297 -8.32564 -1.3476 +9519 6 25.7838 40.7303 1.24723 -3.64329 26.5644 -28.0564 +9520 4 26.2198 41.3001 1.88369 1.46132 -2.86659 8.1156 +9521 4 25.5777 41.3986 0.532216 -2.57635 -28.6607 13.7824 +9522 6 0.458758 22.8928 6.22327 -2.28892 -3.37321 -2.62932 +9523 4 0.911995 22.0955 5.88137 -3.49653 6.37629 4.11618 +9524 4 1.15027 23.4262 6.63616 1.38998 -0.611711 -3.15133 +9525 6 26.2502 35.0072 18.629 11.2346 5.37396 -16.6635 +9526 4 25.9102 35.926 18.5821 -1.77201 -16.2127 4.61622 +9527 4 25.7094 34.5197 19.2578 -0.594129 4.22999 1.61862 +9528 6 16.1509 31.8837 7.54876 40.1408 -29.5169 -1.86921 +9529 4 16.9528 31.2446 7.38162 -38.5191 36.6879 6.5811 +9530 4 16.2422 32.6162 6.9246 8.25996 -4.45471 -3.71716 +9531 6 22.9569 16.8424 28.5503 -18.0144 15.9011 -12.9281 +9532 4 23.0242 16.0615 27.9964 2.65193 -8.47258 -0.731728 +9533 4 22.0914 17.2685 28.2981 23.9965 -14.5366 15.8079 +9534 6 48.817 29.3453 32.1483 10.2159 -3.67765 25.2301 +9535 4 47.913 29.23 31.8533 -10.4354 1.38436 -5.08298 +9536 4 48.8482 28.9579 33.0615 0.343667 8.53482 -20.1614 +9537 6 13.1275 24.857 5.54597 -15.7655 12.0094 -10.6158 +9538 4 12.8967 24.1126 4.95892 -3.19147 7.26676 2.83523 +9539 4 12.4206 25.5605 5.45199 17.9822 -22.1189 1.55356 +9540 6 10.967 20.7149 15.8389 3.49035 -8.57129 -4.90872 +9541 4 10.8232 20.5385 14.8814 6.84933 2.21154 19.4522 +9542 4 11.8211 20.2878 16.0966 -18.2767 7.30584 -13.8769 +9543 6 13.8574 18.376 6.9425 -18.5688 18.5302 -26.9748 +9544 4 14.0551 19.3329 6.99178 3.58444 -10.9562 5.12073 +9545 4 14.2751 17.8929 7.64202 12.8225 -6.30863 19.0643 +9546 6 13.8485 12.9413 30.6405 -7.33075 -24.1801 -9.47477 +9547 4 13.9233 12.3923 29.8469 14.5901 9.31788 -1.12157 +9548 4 13.0284 12.552 30.9634 -3.13873 11.8242 15.1361 +9549 6 17.1199 6.33729 31.2705 58.4108 60.4292 21.9502 +9550 4 16.7347 7.19592 31.0485 -2.55536 -2.82538 -1.05014 +9551 4 16.4932 5.72664 31.0455 -61.4006 -55.6776 -22.0804 +9552 6 7.63858 23.4232 20.5528 2.70849 -2.51933 -11.6338 +9553 4 7.34936 23.0623 19.6936 2.42656 1.66026 8.60009 +9554 4 8.06294 24.2698 20.3247 -2.54411 -7.58863 2.30144 +9555 6 15.6012 36.6828 25.6308 12.0382 0.865576 2.42327 +9556 4 16.546 36.4866 25.8589 -19.7129 13.5166 -7.57965 +9557 4 15.5566 37.5233 25.1245 15.7859 -9.47529 6.9914 +9558 6 0.738662 10.4099 22.1708 -26.6289 -22.4058 -14.7131 +9559 4 0.0268398 10.3645 21.4686 20.8647 0.21224 20.3485 +9560 4 0.555589 9.63254 22.7491 3.84168 18.0907 -12.5939 +9561 6 33.5034 17.3959 33.5951 21.201 30.6084 -13.4811 +9562 4 33.5895 18.3893 33.3705 0.776259 -45.1899 5.95193 +9563 4 34.1847 16.8766 33.1005 -9.04546 14.4589 8.38708 +9564 6 21.6622 19.013 20.7578 31.9274 -22.1518 -4.15649 +9565 4 22.4096 19.6032 20.9777 -11.5486 -3.71871 -1.82252 +9566 4 22.1307 18.1402 20.6082 -20.9219 25.304 3.1187 +9567 6 41.7583 19.992 16.8792 -6.68772 4.02339 -8.69865 +9568 4 42.2438 19.1637 16.9575 3.64207 -5.49479 0.617993 +9569 4 41.579 20.1273 15.9247 3.71595 -2.33609 11.0843 +9570 6 12.0355 14.9654 17.6922 -21.5841 1.26502 -18.8824 +9571 4 11.2182 14.5976 17.276 14.8021 5.3277 12.4216 +9572 4 12.4319 14.255 18.1907 -0.352973 -10.2116 7.98966 +9573 6 23.0172 11.4191 40.7206 -10.7217 24.0381 44.0704 +9574 4 22.9528 12.3236 41.1181 -0.480688 -24.3492 -4.33206 +9575 4 23.3445 11.5906 39.8675 15.3819 0.516123 -37.823 +9576 6 21.0055 28.3299 24.5595 -23.1154 26.0001 -7.02903 +9577 4 20.2855 28.1767 25.1713 -12.8069 16.7504 -3.2857 +9578 4 21.5564 27.6405 24.838 35.6802 -30.9994 4.41974 +9579 6 19.406 13.705 31.9364 14.5236 -8.57279 10.3452 +9580 4 18.7521 13.9469 31.2876 -5.81883 0.611034 -8.78432 +9581 4 18.9142 13.6788 32.7621 -0.186305 1.04404 6.29106 +9582 6 21.5918 2.86134 24.7058 -12.3779 12.1824 -8.79066 +9583 4 21.7274 3.16074 23.7816 9.4572 -7.89437 13.7797 +9584 4 22.4025 2.45534 25.0386 5.22934 2.42127 -4.70961 +9585 6 11.3487 29.9838 18.827 10.5554 -3.16976 4.47537 +9586 4 10.5352 30.5203 18.751 15.2364 -2.61973 2.60085 +9587 4 12.0043 30.4181 19.4217 -22.0541 -6.82347 -15.9561 +9588 6 14.6417 22.3529 8.3686 35.183 35.1516 7.4005 +9589 4 14.0314 23.0645 8.61446 -9.87113 -8.59651 0.991548 +9590 4 15.5117 22.8693 8.31218 -34.203 -30.7208 1.23805 +9591 6 43.9533 23.6664 17.2647 -9.15762 31.6597 -10.4885 +9592 4 44.7744 23.2846 16.9678 11.7125 -13.1472 -3.62648 +9593 4 43.5104 22.9908 17.7726 1.91474 -8.51607 6.21827 +9594 6 28.003 25.5014 27.4986 6.23457 -29.1533 -5.23677 +9595 4 27.4849 26.2827 27.5489 -17.6876 27.9136 1.36856 +9596 4 28.906 25.8001 27.3829 8.21911 6.89622 0.0845564 +9597 6 19.1046 26.8047 33.1413 12.2661 11.24 -48.0243 +9598 4 19.0365 26.4782 32.1917 1.11076 11.999 35.7369 +9599 4 19.4769 27.7251 33.0545 -9.7287 -23.6705 8.34301 +9600 6 6.37289 19.3428 5.67363 -3.21133 -16.2285 8.07537 +9601 4 6.7336 20.019 5.09886 3.22925 8.22387 -6.14542 +9602 4 5.58923 19.7346 6.08082 -0.796808 3.74051 2.3056 +9603 6 37.4835 28.3972 9.67963 -16.8252 8.64443 -22.9196 +9604 4 37.8384 28.0931 10.5154 1.79485 -10.7977 1.13655 +9605 4 37.3056 27.6421 9.07717 9.05958 5.47813 21.4583 +9606 6 17.6994 27.086 11.7957 -23.9049 -9.71644 -0.114793 +9607 4 16.9894 26.5877 11.2784 19.3807 18.9653 23.0761 +9608 4 17.3772 27.2467 12.7205 1.32974 -4.86863 -22.184 +9609 6 12.8804 1.95044 24.1635 -16.9081 23.6463 -41.3936 +9610 4 12.0123 2.42693 23.9788 24.6345 -20.1638 18.4271 +9611 4 12.9602 1.63912 25.0531 -11.2641 -4.9093 21.6908 +9612 6 27.8486 37.1249 33.3037 14.5525 0.843809 -12.8082 +9613 4 27.8306 37.7566 32.5563 -0.261378 -9.54721 11.1245 +9614 4 28.4641 36.389 33.0416 -14.495 18.5162 4.94281 +9615 6 18.6769 12.3657 6.31954 -0.243732 -29.9473 12.6257 +9616 4 18.5317 11.3932 6.23771 0.963018 17.4883 6.62231 +9617 4 18.5535 12.6707 5.42951 -3.51714 10.9469 -19.8301 +9618 6 10.1845 29.3127 24.783 -1.36331 5.89889 -4.08473 +9619 4 10.7465 29.1085 25.5662 -10.353 -5.60455 -9.55427 +9620 4 9.5047 28.6152 24.6271 17.6265 9.93184 12.3415 +9621 6 7.25219 3.30976 16.2618 16.5712 6.01323 38.0962 +9622 4 7.85224 3.92676 16.743 -7.28275 2.21025 -21.7569 +9623 4 7.07626 2.67339 16.9792 -0.839688 -3.96601 -21.0406 +9624 6 32.2032 37.556 1.10106 -1.45173 2.30566 -1.67736 +9625 4 31.7319 37.0242 1.72254 -12.3544 -30.6614 1.12887 +9626 4 32.1826 38.3533 1.61216 9.84976 31.1212 -1.90535 +9627 6 10.4132 10.1536 6.41547 2.6172 -5.66149 -5.23088 +9628 4 9.51094 10.4988 6.43252 -1.43241 7.72691 5.99088 +9629 4 10.888 10.4598 7.20926 -10.4429 3.02901 -4.20627 +9630 6 16.1922 23.2473 37.3836 13.4596 17.9231 -6.20094 +9631 4 16.4628 23.5362 38.2769 -1.8179 -2.41291 -6.91424 +9632 4 16.622 23.8878 36.7607 -9.68345 -13.0364 13.8052 +9633 6 24.0933 14.3373 36.5438 -0.810617 7.47513 6.008 +9634 4 25.0172 14.0983 36.6068 9.64822 -3.29568 0.232999 +9635 4 23.7283 14.0715 37.4031 -3.57511 2.15125 -3.19243 +9636 6 27.4694 18.5535 28.7878 -22.2405 -8.90967 9.68842 +9637 4 27.2463 18.155 29.6474 7.14424 4.94771 -10.1046 +9638 4 26.6163 18.5328 28.3045 10.7583 2.44378 -0.411902 +9639 6 51.5617 10.4928 1.56364 -46.044 -5.31617 -17.9438 +9640 4 50.711 10.1131 1.91707 23.1705 13.8427 -10.0979 +9641 4 52.2015 10.4284 2.24991 18.8641 -3.04547 25.194 +9642 6 31.1163 39.6073 27.5052 16.7753 -4.77526 -29.689 +9643 4 30.6203 39.2762 28.2489 -5.6675 10.9492 15.0474 +9644 4 31.3773 40.5466 27.6182 -8.67746 -20.5696 10.3555 +9645 6 6.90447 35.9666 14.3264 -30.1691 -4.34312 14.222 +9646 4 7.61578 36.3042 13.808 21.2575 5.14969 -9.00238 +9647 4 7.11482 35.0613 14.5906 3.01946 -0.973686 -2.74545 +9648 6 45.5514 7.57029 29.1841 -25.615 -5.69379 -2.02895 +9649 4 44.9198 7.51228 28.4263 15.6429 0.393509 16.1679 +9650 4 45.0848 7.11279 29.9186 7.09759 5.05324 -8.24334 +9651 6 31.3626 20.5603 31.6216 46.5235 7.85379 -13.5612 +9652 4 31.9622 21.3332 31.7077 -20.5518 -6.12612 6.97271 +9653 4 31.9328 19.9839 31.0823 -17.3109 -3.90007 7.28444 +9654 6 43.0286 31.1606 10.377 -16.6603 7.93207 28.9623 +9655 4 42.0878 30.8529 10.4887 24.119 8.07098 -2.29185 +9656 4 43.3099 31.4942 11.272 -6.72297 -13.7816 -28.1326 +9657 6 50.925 25.5606 12.6461 -27.6852 -6.08767 20.8539 +9658 4 50.917 26.3683 12.1731 -8.31821 35.0391 -16.2433 +9659 4 51.8024 25.2628 12.5325 34.7451 -18.8429 0.848912 +9660 6 29.3305 2.97987 3.64738 17.2649 -36.5424 -5.61333 +9661 4 29.6156 3.84373 3.86529 8.03017 35.8359 9.57326 +9662 4 28.4158 3.03535 3.41816 -23.9953 6.75187 -10.8335 +9663 6 53.9216 32.1051 20.3724 -11.2223 -0.478332 -4.16652 +9664 4 54.8523 32.157 20.1701 8.27859 1.2318 1.83366 +9665 4 53.5473 31.7256 19.5583 -4.88871 3.83013 8.11791 +9666 6 41.7036 29.5569 6.48267 17.2638 16.7804 -5.64052 +9667 4 40.7698 29.5903 6.27928 -11.16 5.83742 -3.44443 +9668 4 42.1548 30.305 5.99503 -16.5783 -19.3567 12.2041 +9669 6 37.8345 24.5719 39.3019 -13.0469 -9.65298 -3.86921 +9670 4 37.225 24.2046 38.6488 4.5791 4.74434 1.49749 +9671 4 37.4276 24.3068 40.1372 5.55374 4.45167 1.85829 +9672 6 46.5621 27.5658 23.2944 -23.9279 -33.0439 -11.1022 +9673 4 46.4387 27.4786 24.2739 -2.64996 -4.90603 -22.3791 +9674 4 45.938 26.8598 22.8442 32.7587 35.3455 32.269 +9675 6 9.23408 27.197 8.34767 -28.7607 6.82988 18.9345 +9676 4 8.89078 27.6282 9.16421 9.10203 -8.06063 -16.3167 +9677 4 10.1694 27.1106 8.44975 24.8451 0.83524 4.07321 +9678 6 36.0586 34.168 13.9947 0.546429 -20.5208 -0.995849 +9679 4 35.8317 33.2019 13.9926 1.47243 21.3574 0.844463 +9680 4 36.7518 34.2454 13.3214 -1.12661 -0.38848 2.20278 +9681 6 51.6812 14.492 12.3108 14.2062 7.57429 -10.7818 +9682 4 52.2015 14.4126 11.4771 -7.23407 7.45688 18.698 +9683 4 51.902 15.34 12.7416 -3.60656 -14.3916 -9.37264 +9684 6 15.248 19.6366 32.4109 27.4357 -16.6396 -20.9158 +9685 4 15.2931 19.2358 31.5053 -3.54534 7.22564 18.4797 +9686 4 14.3328 19.7639 32.5881 -28.0981 2.1384 2.91772 +9687 6 27.6849 24.6479 38.3573 2.41004 -14.3506 -18.7558 +9688 4 27.9256 25.2107 39.0738 -0.349992 17.1553 25.2623 +9689 4 28.4455 24.6938 37.7731 2.45273 -2.47407 -6.18841 +9690 6 37.5344 9.26205 13.6222 2.62805 -1.42602 2.92011 +9691 4 37.9029 8.73293 14.3466 0.897712 0.834078 0.0180659 +9692 4 37.323 10.115 14.0326 -0.799981 -1.44542 -1.10758 +9693 6 20.9013 33.2307 26.2512 6.46074 3.54373 3.40895 +9694 4 21.2661 33.4546 27.1222 -3.70394 5.03607 -5.2507 +9695 4 21.0534 32.294 26.1755 2.06129 -12.757 -1.69162 +9696 6 6.58179 13.9421 35.2385 -0.161437 -23.8226 2.06013 +9697 4 6.46846 12.9778 35.1898 -10.847 5.63462 -0.921172 +9698 4 7.53649 14.0007 35.2781 8.40152 11.229 1.63712 +9699 6 10.0736 7.47184 6.87074 6.29005 1.76204 -5.26249 +9700 4 9.16789 7.18556 6.66525 -0.124912 3.45645 -0.864518 +9701 4 10.1825 8.41968 6.63706 -5.90018 -13.0861 3.35766 +9702 6 31.1989 5.96627 11.4256 47.5137 28.7614 23.6553 +9703 4 31.4466 6.13876 12.388 -20.2952 -9.94335 -33.1747 +9704 4 32.0308 6.26994 10.9806 -22.1211 -12.2896 5.82222 +9705 6 12.1387 3.84993 35.2935 2.49551 -0.304387 23.4243 +9706 4 12.8187 4.19174 34.7257 10.4227 4.50872 -14.559 +9707 4 12.5185 4.00559 36.1769 -9.60543 -1.42105 -7.76228 +9708 6 5.33665 6.07757 27.6447 8.69228 -34.5823 40.5077 +9709 4 5.10952 6.83187 28.1919 -5.14709 12.9851 -0.252954 +9710 4 5.24124 6.31071 26.7545 -7.00092 22.4827 -45.3835 +9711 6 13.1372 33.5675 1.68451 12.1014 31.5323 -4.45098 +9712 4 12.5865 33.1501 1.03303 -8.81838 -7.47149 -8.20936 +9713 4 13.3352 34.4765 1.32576 -5.5291 -24.3721 14.4697 +9714 6 44.6567 10.4099 29.0319 -12.4525 3.56979 -21.9228 +9715 4 44.5737 9.45178 29.0051 9.95574 -3.72472 2.79876 +9716 4 44.0317 10.7133 28.332 10.7873 2.60441 13.9487 +9717 6 9.14585 24.5947 6.38022 15.9839 26.3438 -7.73853 +9718 4 8.92734 24.382 5.47582 -9.1117 -9.61509 -8.5024 +9719 4 9.72625 25.3768 6.21639 -5.50996 -10.1894 15.5503 +9720 6 52.5653 27.2618 21.6392 -6.48047 6.16108 13.4347 +9721 4 52.5564 26.3196 21.8908 4.78081 5.6644 -14.1528 +9722 4 52.8195 27.3969 20.7225 3.24319 -11.7343 -6.41363 +9723 6 7.29679 16.9603 33.544 -1.27463 2.76823 -11.9762 +9724 4 7.39152 17.7215 32.9493 2.03275 -0.910573 2.88066 +9725 4 6.37085 16.7082 33.4809 -4.66481 0.778096 -0.770576 +9726 6 43.9289 25.2227 7.97871 -4.96366 -10.0233 8.38699 +9727 4 43.2519 24.7308 8.49213 12.2574 5.67032 -8.3389 +9728 4 43.4276 25.9018 7.51862 -3.04483 5.5605 -3.23664 +9729 6 2.07953 27.1233 13.6028 0.0104954 7.16496 -8.77242 +9730 4 2.15896 26.2371 13.9627 -2.1358 -7.6126 6.04882 +9731 4 2.6502 27.1018 12.8141 -2.23666 2.89631 3.72058 +9732 6 37.3141 18.284 2.18477 -5.94753 -1.23785 7.60386 +9733 4 37.4961 17.5691 1.55591 -3.17432 -0.490531 -1.7774 +9734 4 36.7255 18.8979 1.7415 -3.03937 1.4219 -5.67571 +9735 6 25.0022 10.0655 0.429871 -30.1443 -7.37242 -0.593153 +9736 4 24.272 10.366 41.7528 14.2211 1.75124 5.05026 +9737 4 24.5705 9.40237 1.00583 14.7283 12.1051 -6.86513 diff --git a/examples/amoeba/dump.ubi.32.test b/examples/amoeba/dump.ubi.32.test new file mode 100644 index 0000000000..743c5e68dc --- /dev/null +++ b/examples/amoeba/dump.ubi.32.test @@ -0,0 +1,19492 @@ +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +9737 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 5.4990000000000002e+01 +0.0000000000000000e+00 4.1909999999999997e+01 +0.0000000000000000e+00 4.1909999999999997e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 9.9631 5.60476 0.008413 6.29384 29.5246 19.0744 +2 2 9.59585 5.61686 40.5223 49.6095 -15.082 -19.7261 +3 2 8.19009 6.07902 40.3725 -38.3002 -36.0401 31.6494 +4 3 7.228 5.27674 40.5663 25.6537 34.3003 -15.2325 +5 4 9.24854 5.32486 0.671238 -4.4712 -3.37565 -7.28982 +6 4 10.3108 6.54317 0.309331 -11.8382 -28.5043 -8.77497 +7 4 10.7093 4.95217 0.170763 9.79439 -2.80927 4.02983 +8 4 10.3426 6.38567 40.0332 -19.5644 -29.2331 3.89265 +9 2 9.77742 4.13431 39.9813 -28.2245 -12.7597 2.79543 +10 2 9.48564 3.81758 38.4974 43.5672 -24.1926 -8.96475 +11 5 10.1176 2.11667 38.0047 -9.19737 11.9016 12.5734 +12 2 9.21456 1.10205 39.2112 31.2522 23.9396 11.6177 +13 4 8.99594 3.48122 40.5964 28.5446 19.8656 -13.413 +14 4 10.8136 3.75653 40.1807 -3.6049 4.77507 7.99264 +15 4 10.0744 4.47991 37.8007 -16.03 7.55553 14.4224 +16 4 8.42529 3.84402 38.2863 -20.8998 9.83371 -6.83213 +17 4 9.47601 1.46641 40.2263 -2.07893 -1.87234 0.341628 +18 4 9.53146 0.065851 39.1813 1.34892 -20.4385 -9.90461 +19 4 8.1577 1.22135 39.0727 -30.8502 -1.48556 -5.54631 +20 1 8.07565 7.408 40.3203 38.3461 4.68909 -14.5778 +21 2 6.84679 8.08521 40.1985 -59.0929 12.5985 8.76694 +22 2 6.18936 7.48414 38.9048 -11.7821 0.575019 41.3478 +23 3 6.7346 7.67531 37.8418 13.9355 0.826162 -41.115 +24 4 8.95137 7.92937 40.1018 -13.7432 5.12585 4.7357 +25 4 6.17099 7.78674 41.0889 17.7478 9.29385 -16.8634 +26 2 7.04543 9.68435 40.1788 6.06779 -36.4281 36.3417 +27 2 5.78315 10.5437 40.1541 10.0153 13.6856 -31.2349 +28 2 4.87823 10.4891 38.8981 8.0898 32.2503 -21.0798 +29 3 5.10035 11.2936 37.9551 -6.38068 -25.249 23.2549 +30 1 3.78765 9.69754 38.9447 7.74282 -10.5609 -2.0448 +31 4 7.77413 9.91905 39.4336 6.93206 10.4159 -38.5359 +32 4 7.65159 10.0279 41.0787 -15.5363 -12.6708 -2.68622 +33 4 6.21166 11.5927 40.0353 -14.0103 -9.11046 14.0038 +34 4 5.24199 10.4471 41.1154 -6.90019 6.03163 0.39253 +35 4 3.64982 9.13451 39.798 -8.63839 -3.4701 -4.98201 +36 4 3.18526 9.53497 38.0983 12.4509 11.2825 18.2671 +37 1 5.03649 6.76821 39.0271 29.2025 12.626 -49.9624 +38 2 4.1742 6.30537 37.9199 2.45922 -5.77224 11.4432 +39 2 2.7281 6.64357 38.2301 -33.27 13.9739 -28.2234 +40 3 2.48558 7.27851 39.247 -7.20167 1.94081 18.2399 +41 4 4.56901 6.92293 39.8729 -36.0812 -3.10094 47.9009 +42 4 4.41115 6.93099 37.0362 4.08063 -6.87028 -11.6053 +43 2 4.30896 4.77224 37.6863 5.60806 -34.2262 -10.7438 +44 2 3.61194 3.83713 38.7945 21.7291 41.8848 -7.6362 +45 2 5.81981 4.32753 37.5156 -0.302636 -10.5955 -12.2236 +46 2 3.74184 2.37563 38.4472 -21.3499 -20.7746 -35.862 +47 4 3.79188 4.51145 36.7016 6.3754 10.432 9.00978 +48 4 2.54774 4.08441 38.8361 -15.7139 1.18722 1.17999 +49 4 4.01487 4.13828 39.7949 0.987415 -11.5324 -1.87366 +50 4 6.38959 4.49596 38.46 -5.87199 -9.93517 1.91854 +51 4 6.36771 4.97617 36.7815 -14.8228 -10.6264 -0.132465 +52 4 5.90888 3.19548 37.1534 1.72477 39.701 11.5881 +53 4 3.39383 2.18531 37.3739 6.37275 7.50384 16.1992 +54 4 3.10231 1.69487 39.022 -2.76045 -1.11045 15.6564 +55 4 4.76015 2.00007 38.4839 16.883 -5.45935 8.37891 +56 1 1.68415 6.36719 37.3348 37.2769 -12.9922 15.6035 +57 2 0.304736 6.65563 37.6783 -19.186 -35.7743 -0.468083 +58 2 54.3638 5.41499 37.39 23.5408 9.01503 -19.9847 +59 3 54.8016 4.481 36.67 -18.0502 12.9096 17.6943 +60 4 1.81134 5.6821 36.5646 -2.38907 6.77101 2.69516 +61 4 0.26398 6.68603 38.7911 -5.02605 17.0245 3.77253 +62 2 54.6928 7.87629 36.9427 9.14228 37.5998 28.2049 +63 2 0.656467 9.08157 36.7109 -0.0956801 -8.96924 -14.639 +64 2 1.56488 9.23116 35.5658 -28.7887 -16.4207 21.28 +65 2 0.518242 10.1807 37.599 12.0453 -33.0617 -42.3022 +66 2 2.2549 10.4284 35.3456 -0.685553 9.51875 21.9154 +67 2 1.26608 11.2953 37.3573 -6.55985 56.8791 72.0683 +68 2 2.14201 11.4551 36.3269 43.9558 24.4422 -61.5967 +69 4 53.8494 8.28091 37.614 11.6877 -9.2043 -14.6276 +70 4 54.1796 7.56606 36.0251 1.84695 0.514683 -15.8045 +71 4 1.67027 8.40603 34.832 -2.56062 3.42592 3.08894 +72 4 54.8243 10.1788 38.4192 -16.1978 -2.83683 23.7337 +73 4 2.90465 10.5398 34.4584 1.04403 1.06161 3.93542 +74 4 1.2044 12.0958 38.199 3.2453 -15.1518 -32.2206 +75 4 2.76002 12.4636 36.1598 -24.4207 -43.5556 11.8549 +76 1 53.0705 5.5478 37.8043 -13.4682 25.7632 10.8407 +77 2 51.945 4.63101 37.5291 33.8243 -29.5042 -37.7332 +78 2 50.7838 5.44293 36.986 4.21111 -0.422475 -19.7833 +79 3 50.2621 6.29965 37.7355 -1.55474 -12.1519 -25.7528 +80 4 52.801 6.45436 38.3333 3.61532 -42.2821 -15.9338 +81 4 52.3053 3.83112 36.7028 -14.0928 30.7972 24.0178 +82 2 51.5456 3.79903 38.7793 9.75018 1.06621 4.26496 +83 2 50.3519 2.79661 38.4832 35.7171 10.1602 1.47909 +84 2 52.8174 3.02556 39.2171 -10.4567 -30.55 12.3487 +85 4 51.3202 4.51835 39.6193 -10.3559 -7.38818 -7.14654 +86 4 50.5612 2.13754 37.5331 -9.75373 16.6535 26.894 +87 4 49.4557 3.43665 38.3668 -10.8276 -7.01925 -6.76558 +88 4 50.2008 2.17632 39.4156 -2.83245 -1.1989 -13.0752 +89 4 53.3224 3.52205 40.064 3.32837 5.49303 2.41605 +90 4 53.5736 2.86114 38.4382 5.5955 2.25759 -8.48168 +91 4 52.5769 1.98664 39.5815 -0.855844 10.0945 -0.110617 +92 1 50.4393 5.19673 35.6351 -19.7264 9.67141 42.9571 +93 2 49.1691 5.71413 35.1171 8.57247 21.8964 -7.76629 +94 2 48.0882 4.65728 35.3507 -19.9883 30.8425 14.9148 +95 3 48.2827 3.53875 34.9335 -4.48089 -38.0316 -8.70437 +96 4 50.7426 4.33028 35.1784 2.31221 -1.81777 -1.86606 +97 4 48.9711 6.6281 35.7521 -11.2206 -0.672417 -16.6265 +98 2 49.2032 6.03091 33.5236 -0.851856 65.2811 26.1578 +99 2 47.9587 6.87959 32.9935 21.6676 -24.5773 11.3759 +100 2 48.0434 7.32811 31.5002 51.7858 -12.5586 -5.19204 +101 2 48.2074 6.22405 30.3724 28.294 -23.2516 17.4346 +102 1 48.1983 6.77555 28.9911 -71.9632 -28.6889 -6.605 +103 4 49.3393 5.11986 33.0139 -2.20502 -45.3575 -27.512 +104 4 50.0955 6.63289 33.1892 -0.645528 -4.64769 17.8413 +105 4 47.8013 7.74388 33.6913 1.36166 0.224784 -7.99748 +106 4 47.0904 6.22572 33.1496 -13.2574 -0.904539 -3.87726 +107 4 49.004 7.98659 31.3992 -27.9616 -9.11626 3.58403 +108 4 47.1978 7.96127 31.27 -20.0009 14.5444 -5.73856 +109 4 47.5417 5.33248 30.4619 -18.467 18.3391 -3.45282 +110 4 49.1897 5.66674 30.5732 -8.59668 22.4275 -14.4147 +111 4 48.9982 7.27964 28.7313 27.9214 19.6218 -9.55881 +112 4 47.3685 7.40493 28.8518 27.8731 -11.8414 7.77703 +113 4 48.0065 6.08598 28.2169 17.275 11.5652 28.2934 +114 1 46.9206 5.03778 35.9702 10.3577 18.9682 5.15831 +115 2 45.6557 4.25932 36.0398 9.08885 -0.641191 -14.1305 +116 2 44.8836 4.39003 34.674 17.924 -7.95306 73.8288 +117 3 45.3111 5.13887 33.8455 4.25406 24.8458 -47.415 +118 4 46.9247 5.98842 36.4259 -8.42518 -21.6093 -9.66 +119 4 45.9322 3.16772 36.074 -4.07513 2.77881 8.35057 +120 2 44.7235 4.66099 37.2497 -7.79148 27.6424 25.8282 +121 3 44.4559 6.1146 37.2032 37.085 -18.356 15.5747 +122 2 45.2448 4.26963 38.7181 22.7861 29.0575 -8.8559 +123 4 43.727 4.13168 37.1283 17.3832 10.5512 -0.864114 +124 4 45.2761 6.59903 37.5183 -34.0557 -21.4787 -11.7364 +125 4 45.8733 4.97275 39.4014 -10.271 -7.81482 -36.7347 +126 4 45.822 3.36133 38.5799 14.1835 -15.9263 3.29814 +127 4 44.4672 3.97387 39.4102 -27.3329 -5.40347 3.37723 +128 1 43.7561 3.68722 34.6039 -10.1769 -38.5504 10.0379 +129 2 42.7898 3.65331 33.5354 16.9998 -6.12306 -24.86 +130 2 41.7694 4.78815 33.7404 2.26966 -0.410412 -51.1213 +131 3 41.2522 5.37284 32.7445 13.6537 -18.3748 18.9894 +132 4 43.5295 2.98811 35.3697 5.99608 22.1557 -16.865 +133 4 43.3523 3.94914 32.5036 -19.5402 -19.5629 37.0771 +134 2 42.0755 2.18627 33.4863 21.9074 34.2086 -29.4327 +135 2 42.9391 0.859767 33.721 -6.85443 30.257 35.6042 +136 2 42.2358 41.4668 33.4285 -9.81834 -3.65893 -31.5778 +137 2 44.2283 0.854864 32.9471 53.2312 13.9788 40.9195 +138 4 41.6117 2.20331 32.4686 -4.39523 -13.2201 2.61812 +139 4 41.2586 2.27352 34.2121 -10.6776 -10.6054 4.67488 +140 4 43.2056 0.83773 34.8124 -0.343624 1.56324 -2.51079 +141 4 42.8118 40.5237 33.3983 6.69029 -0.569008 16.3673 +142 4 41.9597 41.5484 32.3684 -17.7546 -2.75522 -9.07631 +143 4 41.3245 41.3357 34.0216 -8.62626 -3.98831 3.9624 +144 4 44.0827 0.853311 31.8896 -3.53557 -4.02089 -36.565 +145 4 44.8236 41.822 33.2847 -5.06735 25.2561 -15.1823 +146 4 44.8583 1.80877 33.1923 -14.5958 -31.7921 -4.90526 +147 1 41.5264 5.19611 34.9737 -24.8334 44.6246 6.63495 +148 2 40.6685 6.33721 35.2699 -7.96634 19.3021 -16.1623 +149 2 41.3876 7.74941 35.097 -11.5591 -21.8484 1.81155 +150 3 40.7047 8.75309 34.8417 -6.4948 4.14558 0.128999 +151 4 41.7654 4.68652 35.8013 13.1043 -20.8107 18.8359 +152 4 39.8731 6.44712 34.4383 10.8594 -11.0445 14.3032 +153 2 39.8592 6.12601 36.6093 -15.5564 -7.24317 -37.5678 +154 3 40.7443 5.88444 37.6633 23.6025 16.5055 19.3857 +155 2 38.9047 4.85477 36.5395 -12.0583 61.1722 12.675 +156 4 39.322 7.07341 36.7706 -11.99 4.52079 9.89046 +157 4 41.1265 6.74598 37.8781 -3.93551 -10.4676 -4.79928 +158 4 38.0585 4.98564 35.7954 18.0693 -6.53498 -0.435941 +159 4 38.3566 4.77654 37.5171 8.14363 -6.92414 -3.72239 +160 4 39.543 3.99696 36.3828 0.165947 -30.6128 -6.86199 +161 1 42.7342 7.80416 35.136 -13.9315 11.8694 11.7976 +162 2 43.5142 9.02936 34.9481 17.7181 -46.9691 35.2138 +163 2 44.5073 9.42999 36.0349 -55.8537 -50.7646 50.0035 +164 3 45.375 10.2125 35.7599 43.422 25.9365 -4.74067 +165 4 43.1984 6.94617 35.4338 19.599 0.647333 4.29925 +166 4 44.1406 8.86955 34.0842 9.16679 3.97336 -28.1373 +167 4 42.9197 9.91228 34.8204 -18.5221 19.1219 -12.9063 +168 1 44.2798 8.93745 37.3587 -4.0043 10.1489 -58.0949 +169 2 45.1948 9.27519 38.4238 -4.17993 36.3676 -26.0855 +170 2 46.5575 8.73344 38.0061 12.5522 -20.4469 18.6928 +171 3 46.7331 7.49794 37.7681 -6.88831 31.8582 -6.20611 +172 4 43.377 8.45873 37.5311 9.37776 2.67644 11.4724 +173 4 45.2318 10.4158 38.3238 5.33405 -13.6354 14.6161 +174 2 44.7823 8.84756 39.8415 35.39 -32.4267 -9.44324 +175 2 45.5211 9.64049 40.9405 -33.0234 -16.4934 27.578 +176 2 45.0293 11.1067 41.0295 26.955 13.1382 1.75579 +177 2 45.9939 11.883 0.056845 5.44769 -3.52142 -7.77113 +178 1 45.567 13.2463 0.389189 -21.8942 22.5552 58.7427 +179 4 44.9649 7.71121 39.9163 -1.68078 22.7299 4.94117 +180 4 43.7292 8.96914 40.0006 -34.3585 3.91778 0.788359 +181 4 46.6326 9.56148 40.8729 -4.12637 -0.755434 -1.7729 +182 4 45.1589 9.15652 0.052119 21.5355 9.01144 -26.2886 +183 4 44.0384 11.1525 41.4882 -17.6691 -1.8484 1.78047 +184 4 44.9645 11.6456 40.0488 1.32443 -5.52779 3.51863 +185 4 46.9936 12.0079 41.4163 -11.0521 -7.71607 17.8496 +186 4 46.0863 11.2417 1.01939 6.64185 25.7549 -16.0759 +187 4 45.6176 13.9315 41.5535 6.39074 -1.54943 -2.93714 +188 4 46.1207 13.6426 1.21669 -15.3499 -18.2055 -38.2327 +189 4 44.572 13.3465 0.725918 28.6554 -12.4083 -12.8179 +190 1 47.5723 9.62675 38.0225 1.62241 16.525 -13.2778 +191 2 48.9413 9.31976 37.6447 28.3505 6.17866 3.85392 +192 2 49.7947 9.65595 38.897 -51.2415 76.6103 -24.0977 +193 3 49.6063 10.7902 39.4401 12.9093 -42.4425 -12.577 +194 4 47.4538 10.6389 38.3066 -1.81401 -22.4625 -4.08398 +195 4 49.0905 8.23756 37.4201 -8.03606 -0.867672 -0.903629 +196 2 49.3577 10.1392 36.3514 -15.5639 -8.86216 -34.5575 +197 3 48.3381 9.84531 35.2995 20.2521 4.60838 26.9691 +198 2 50.6821 9.73379 35.6575 -13.1705 -1.52152 26.2758 +199 4 49.443 11.2403 36.5183 -14.2645 -0.263993 8.70321 +200 4 47.5106 10.2398 35.5579 0.218555 2.62212 3.26783 +201 4 50.9323 10.3465 34.7687 -2.88514 -3.55444 -7.60949 +202 4 50.7732 8.65192 35.4951 -3.14548 -9.24106 -12.1943 +203 4 51.4763 9.94768 36.3674 17.1427 5.0591 10.0517 +204 1 50.5022 8.69828 39.4305 24.0939 -43.466 77.1583 +205 2 51.0483 8.71922 40.8082 -0.802123 10.2433 -32.8315 +206 2 52.5183 8.33859 40.7231 46.1376 25.1574 58.8821 +207 3 52.8914 7.33748 40.1143 13.0446 10.4001 -14.6089 +208 4 50.6189 7.73433 39.1341 -5.48208 -8.91176 -29.3848 +209 4 51.0045 9.75097 41.1725 -0.547397 17.2241 4.09797 +210 2 50.2922 7.85282 41.8455 19.6626 -50.7873 -7.63422 +211 2 50.2811 6.29504 41.471 -17.2864 -17.6708 26.7503 +212 2 48.8668 8.31684 0.212195 -17.3783 63.506 12.4232 +213 2 49.3691 5.38294 0.512646 14.3884 65.6628 -4.02696 +214 4 50.9326 7.9114 0.860642 -12.3241 5.1929 3.57402 +215 4 51.3127 5.83882 41.5287 -4.74499 10.5855 -5.5164 +216 4 49.8921 6.13652 40.4532 1.6457 0.843055 -11.9856 +217 4 48.0317 8.06123 41.424 13.0217 -7.20036 -2.54126 +218 4 48.8693 9.49201 0.254246 -0.917701 -32.4673 -2.46528 +219 4 48.5263 8.05212 1.23597 1.41612 -6.96817 -0.649274 +220 4 48.2816 5.57755 0.309314 6.34191 -1.32326 5.14384 +221 4 49.6363 5.72968 1.56057 -11.1106 -15.1353 -5.99489 +222 4 49.54 4.32324 0.397743 7.27301 -24.1582 -2.3836 +223 1 53.3925 9.14738 41.5454 -19.7766 -15.6836 -47.6014 +224 2 54.8543 9.29866 41.641 -12.5045 -20.0873 29.727 +225 2 0.407838 8.25913 0.762984 -29.7207 32.5524 -37.8245 +226 3 54.8643 8.2564 1.86493 17.0269 -29.0845 20.332 +227 4 52.9285 9.69819 0.341812 -9.11605 14.2566 13.2302 +228 4 0.291486 9.0623 40.6877 9.99865 -5.39191 -34.8298 +229 2 0.359683 10.7121 0.203065 -6.90664 -3.88067 -14.6485 +230 3 54.4765 11.8025 41.752 -11.2022 -21.2627 -5.88002 +231 2 1.6614 11.1001 41.4135 2.5167 -27.9916 -13.3179 +232 4 0.487415 10.6137 1.28953 0.410521 18.1219 13.0764 +233 4 54.0953 12.1937 0.613553 1.59003 1.59721 11.7532 +234 4 1.92456 12.0955 41.7398 14.8193 23.7252 4.53742 +235 4 1.52762 11.126 40.2979 3.61624 1.93597 7.36374 +236 4 2.5241 10.4069 41.6364 -8.38015 7.04993 1.52106 +237 1 1.45864 7.53391 0.367476 0.545631 9.71791 -21.8799 +238 2 2.25081 6.65311 1.15507 26.446 -0.0641839 -18.4938 +239 2 3.7671 6.96757 0.917085 -57.4365 -22.4689 85.9929 +240 3 4.15047 7.41488 41.7757 21.4144 12.1214 -29.7802 +241 4 1.8001 7.62601 41.3064 3.76941 -0.348546 3.21752 +242 4 1.98413 6.84865 2.19976 1.77378 -4.57114 13.3572 +243 2 1.98593 5.20856 0.673411 -39.0557 8.05152 -2.47083 +244 2 0.499001 4.77546 0.950638 51.92 -35.3278 3.54994 +245 2 0.302449 3.38226 0.307039 12.2804 5.92691 27.6936 +246 2 0.318833 4.59091 2.46762 -57.1886 17.9845 23.4913 +247 4 2.62035 4.47984 1.15306 24.0478 -12.5257 10.4353 +248 4 2.17019 5.14075 41.4887 6.74012 -0.473312 -2.7006 +249 4 54.8482 5.46061 0.448133 -33.0903 28.7369 -7.07308 +250 4 54.2241 3.15851 0.337643 -14.6094 -12.7265 -2.24176 +251 4 0.881511 2.58656 0.876485 -8.96903 11.0382 -11.5819 +252 4 0.635114 3.38296 41.1822 2.70741 -4.49002 -20.1461 +253 4 0.991181 3.80938 2.86091 2.53728 -4.51346 7.06316 +254 4 54.1796 4.30541 2.72425 38.6722 3.44969 -10.622 +255 4 0.495432 5.52724 3.08531 2.73328 -11.7655 -13.2166 +256 1 4.49387 6.66874 2.05101 59.25 35.5651 -63.8633 +257 2 5.97745 6.82619 2.08157 -13.5783 -40.6566 -15.6714 +258 2 6.57448 5.47381 2.54294 67.6927 12.9151 50.3283 +259 3 7.53922 5.43765 3.33186 -5.78511 6.85237 -12.8739 +260 4 4.10191 6.33546 2.9164 -11.2688 -10.0369 11.6191 +261 4 6.35409 6.85375 1.02753 1.73229 12.3732 3.55997 +262 2 6.47001 8.00523 2.96248 -35.1701 -2.47648 -9.01657 +263 2 6.52316 9.38515 2.26526 -52.089 -36.3571 -52.5381 +264 2 6.66039 10.5311 3.17647 23.2175 30.5211 32.7092 +265 3 7.81872 10.9467 3.49478 5.10838 -9.19539 -6.96115 +266 3 5.64173 11.0573 3.6767 -20.5888 -1.64097 0.158765 +267 4 7.42654 7.87231 3.41702 35.4584 -16.2138 5.63399 +268 4 5.81838 7.86205 3.84167 -4.54492 27.3919 10.2645 +269 4 5.56237 9.49095 1.59664 20.5708 1.89307 25.306 +270 4 7.29681 9.38215 1.47849 13.2355 1.21078 1.19218 +271 1 6.08096 4.31767 2.17259 -39.414 -15.8224 -24.7678 +272 2 6.39518 2.91476 2.36043 4.12081 37.0723 19.1814 +273 2 7.75633 2.62628 1.79624 63.8838 -9.4865 -25.3011 +274 3 8.33634 3.36937 0.946953 -27.4154 -16.213 26.3787 +275 4 5.28658 4.43126 1.58002 -24.0887 -1.16266 -20.2566 +276 4 6.54455 2.77577 3.45017 -8.86613 -5.70482 8.60941 +277 2 5.25427 2.02933 1.82805 -30.6144 -48.6247 5.61864 +278 2 3.85552 2.1153 2.66383 78.486 27.413 32.1434 +279 2 4.87851 2.27508 0.297641 -10.4566 -15.7718 22.2154 +280 4 5.65998 0.937168 1.99721 -15.6319 23.5495 -14.0675 +281 4 3.98898 1.63213 3.72107 -1.04911 23.3354 -24.3429 +282 4 3.15409 1.48884 2.20213 -45.477 -24.0418 -26.2275 +283 4 3.51802 3.20813 2.70746 -2.40249 -20.6527 6.6832 +284 4 4.39172 3.24426 0.119355 -1.44384 9.21297 0.0772101 +285 4 4.19746 1.51559 41.6955 12.4172 8.09212 16.5491 +286 4 5.82002 2.28129 41.6778 17.5327 1.3005 -22.4945 +287 1 8.43941 1.53208 2.30673 1.7292 42.4201 -39.4356 +288 2 9.76672 1.10452 1.81012 11.995 -19.5667 23.3003 +289 2 9.60964 41.7637 0.921245 4.05677 21.7498 -11.1929 +290 3 8.59567 41.087 1.06007 7.18507 -15.5872 -8.58634 +291 4 7.90606 0.81761 2.76924 -8.42032 -19.931 16.3865 +292 4 10.4026 1.87877 1.34085 -18.5158 15.1062 -12.7744 +293 2 10.6232 0.647963 3.0246 -34.7832 -39.5023 14.4787 +294 2 11.0993 1.6812 4.04079 16.2934 16.5377 23.708 +295 2 12.4719 2.27616 3.59128 -46.8378 -2.52013 6.7155 +296 3 13.4675 1.63575 4.02276 22.0629 14.477 -13.463 +297 3 12.4471 3.24187 2.73298 15.8946 -22.2661 28.0778 +298 4 11.4641 0.045385 2.63277 10.8271 5.92943 5.75519 +299 4 10.0353 41.7446 3.607 8.35649 20.5438 -12.0897 +300 4 11.2832 1.11765 5.0427 -4.51453 13.9694 -21.6118 +301 4 10.341 2.4932 4.3105 9.65416 -13.2167 -8.7997 +302 1 10.6494 41.4676 0.039711 8.78515 0.440053 18.9323 +303 2 10.7217 40.2184 41.1909 10.2574 -28.5822 12.1248 +304 2 10.6889 38.8907 0.171469 -17.3791 70.2346 -13.2363 +305 3 10.1368 37.8928 41.652 0.864281 -20.5458 12.6113 +306 4 9.82473 40.2067 40.5786 -14.2689 -8.84554 -18.4029 +307 2 12.0478 40.1799 40.3262 -31.3786 20.6535 10.6233 +308 2 12.4388 41.6551 40.4794 16.223 20.8678 -10.392 +309 2 11.8805 0.34241 41.7792 -28.1233 -36.7072 -34.4959 +310 4 11.9102 39.8982 39.2292 -1.08614 0.893428 17.4874 +311 4 12.7409 39.4563 40.8087 9.93344 3.46544 -3.32375 +312 4 12.0845 0.391154 39.5895 8.62314 -16.2997 14.2071 +313 4 13.5502 41.7447 40.5643 -1.70925 0.910467 -12.4735 +314 4 11.7305 1.40344 41.6414 -9.5626 24.5309 -2.35213 +315 4 12.5687 0.26268 0.684216 19.8182 -9.73862 27.9097 +316 1 11.1854 39.0885 1.40191 34.1901 -11.3327 18.3686 +317 2 11.4785 38.09 2.41707 -37.5808 13.2867 4.32174 +318 2 10.2405 37.7763 3.3402 -0.155099 -13.1844 6.87934 +319 3 10.4378 36.9653 4.27207 -11.6928 9.67513 -22.7546 +320 4 11.6756 39.9703 1.62918 -8.97807 -2.58442 -2.36164 +321 4 11.7153 37.147 1.89269 -3.37493 -11.1801 -2.58831 +322 2 12.7263 38.4682 3.25859 -32.7454 -15.529 27.3397 +323 3 12.5885 39.7408 3.87129 1.54426 18.5893 -11.5354 +324 4 13.5945 38.4441 2.61946 23.9879 5.88222 -14.7576 +325 4 12.9197 37.685 4.04183 -3.566 10.9198 -2.82194 +326 4 11.9285 39.8531 4.57214 8.5625 -16.1459 -5.7164 +327 1 8.98961 38.3717 3.14779 19.3135 28.1448 -76.0315 +328 2 7.78009 38.1002 3.90315 -4.26896 22.0341 0.229441 +329 2 6.83069 37.1869 3.18241 -25.8564 -25.3069 -16.1867 +330 3 6.84398 36.9785 1.97125 20.9058 23.903 -13.4458 +331 4 8.79049 38.9506 2.20714 10.5577 -30.8167 54.9659 +332 4 8.11274 37.5073 4.75427 1.14536 -6.32615 23.8911 +333 2 7.0077 39.4163 4.32571 4.21253 -4.87986 18.678 +334 2 7.75781 40.1168 5.42156 46.58 -14.1846 12.934 +335 3 8.30143 41.2262 5.21331 -14.6188 11.6514 -5.86083 +336 3 8.10545 39.4797 6.46784 -18.045 3.20128 -4.6129 +337 4 6.01572 39.173 4.78754 -1.72287 0.045533 -10.2864 +338 4 6.87032 40.2048 3.55457 -4.98407 -10.6589 -12.5629 +339 1 5.91154 36.4899 3.88964 18.6928 -0.691686 25.3425 +340 2 4.98537 35.571 3.20749 -24.0931 31.8814 30.8723 +341 2 3.79198 36.4499 2.67545 58.5623 50.3783 54.6165 +342 3 3.60244 37.6478 3.05835 4.98938 -42.2114 -12.2812 +343 4 5.945 36.5545 4.93654 -10.5756 -4.83423 -16.3239 +344 4 5.5221 35.038 2.40161 -3.05594 2.46612 -11.4716 +345 2 4.40384 34.4728 4.15145 -1.70261 45.9252 5.92389 +346 3 3.98498 35.0725 5.41787 -8.00202 -46.5665 -16.5053 +347 2 5.48475 33.4747 4.46048 0.249803 -29.9924 71.6177 +348 4 3.54337 34.0389 3.61058 -6.82183 -12.9435 7.69028 +349 4 3.62675 34.2747 5.86698 6.39679 27.749 2.05336 +350 4 5.85279 32.9868 3.57629 11.3184 -16.9973 -22.3871 +351 4 5.09248 32.6743 5.23041 8.97186 17.4623 -32.7541 +352 4 6.34746 33.9006 5.03324 -0.476546 4.78606 -11.5797 +353 1 3.00152 35.8184 1.87366 -46.1462 -42.5584 -55.0681 +354 2 1.77021 36.3468 1.35692 -36.7765 14.163 11.1031 +355 2 0.721356 36.5788 2.57059 18.2386 -29.7925 23.2574 +356 3 54.9678 37.5551 2.63992 10.9193 3.0322 -8.68025 +357 4 3.31287 34.9586 1.40066 1.19836 -3.77239 4.28893 +358 4 2.05059 37.3327 0.922928 -11.4048 10.7741 9.22697 +359 2 1.07197 35.5705 0.158527 41.3495 -39.9506 -9.05678 +360 2 1.73776 35.9497 40.6674 -26.4234 39.8053 33.0301 +361 2 54.5322 35.7209 0.133627 -14.8072 -12.0564 -1.20894 +362 2 3.23928 35.9487 40.63 7.11928 -24.1756 -12.68 +363 4 1.32474 34.4514 0.269568 -7.211 20.0201 5.35532 +364 4 1.47926 37.0502 40.6385 -3.87579 -7.90549 -26.2729 +365 4 1.36122 35.3789 39.7771 -4.72819 3.84386 12.155 +366 4 54.087 35.0558 41.2526 3.68912 7.63158 3.17282 +367 4 54.2076 36.7772 41.8385 0.949253 -6.55132 4.09096 +368 4 54.0676 35.3362 1.10912 4.22691 12.456 -17.368 +369 4 3.57003 34.9443 40.8434 9.13412 -24.8126 8.40569 +370 4 3.78301 36.5792 41.3142 5.34684 18.5101 18.1918 +371 4 3.6567 36.127 39.6372 -0.20476 7.44967 -14.9904 +372 1 0.712989 35.6055 3.58431 38.0557 9.26554 -59.6495 +373 2 0.05279 35.6483 4.83915 -15.0961 2.42646 38.658 +374 2 0.191347 37.0144 5.48801 7.00468 33.8104 1.40802 +375 3 54.154 37.7008 5.76148 35.4113 -11.6645 -8.2681 +376 4 1.23482 34.733 3.35856 -11.2418 4.01634 10.8504 +377 4 53.9671 35.581 4.69172 -20.2496 -5.13772 -12.456 +378 2 0.463881 34.4895 5.81355 17.031 15.9659 -33.5139 +379 2 54.8083 34.3393 7.16558 -30.7527 -16.2072 -11.1445 +380 2 0.00712 35.4957 8.10271 3.59003 -8.69902 15.3198 +381 3 54.0967 36.3529 8.34542 -1.77732 -9.94333 -12.6544 +382 3 1.07192 35.4587 8.7399 35.3598 16.353 18.5034 +383 4 1.56574 34.5304 5.94519 0.590681 0.639559 4.32925 +384 4 0.280894 33.5741 5.23349 -1.52963 -16.3279 0.16603 +385 4 0.223173 33.3947 7.64873 -6.8885 8.42796 -3.46601 +386 4 53.7112 34.1554 6.97481 9.65493 -2.46487 7.60139 +387 1 1.50649 37.4152 5.65526 -22.458 -31.2308 -17.0045 +388 2 2.02438 38.6379 6.15097 -3.22056 29.1656 36.4104 +389 2 1.58588 39.8651 5.40701 -13.5031 20.9194 -76.104 +390 3 1.07209 40.8553 5.93778 8.03965 -15.1327 11.1864 +391 4 2.24702 36.741 5.38136 -6.00826 1.88497 2.51587 +392 4 1.72629 38.833 7.20228 -22.1923 -11.9073 0.0585309 +393 2 3.51949 38.6121 6.24971 43.6984 -50.5664 -0.0787057 +394 2 4.11017 39.7004 7.10642 -5.48661 12.2779 -12.8977 +395 3 4.55887 40.7033 6.57435 6.12607 11.2234 -5.55098 +396 1 3.97545 39.5562 8.42942 -13.6958 7.00999 41.6346 +397 4 3.92653 38.5973 5.19958 6.67843 9.43594 11.2804 +398 4 3.90699 37.6191 6.72902 -10.8805 23.4385 -12.7616 +399 4 3.35162 38.8096 8.83526 13.2612 9.60447 -6.60232 +400 4 4.25023 40.3377 9.09595 -2.56729 -20.1743 -21.9158 +401 1 1.64621 39.8034 3.99517 -50.1719 52.4074 67.8966 +402 2 0.960547 40.8538 3.14427 -3.37695 -31.9032 -17.009 +403 2 54.4047 41.0035 3.47138 71.1401 19.2662 2.3079 +404 3 53.9887 0.221409 3.63964 -22.8765 18.4333 9.81455 +405 4 2.07659 38.9926 3.63308 18.9969 -31.9912 -34.7926 +406 4 1.39808 41.8727 3.34889 0.835518 -9.01277 1.27119 +407 2 1.14841 40.4887 1.56595 -9.49555 20.2148 39.7014 +408 2 0.469253 41.6189 0.677094 10.8075 11.2475 47.495 +409 2 2.6528 40.4777 1.25625 -15.459 -47.3647 -39.6369 +410 4 0.776571 39.4398 1.40308 -11.1955 11.1351 -6.38222 +411 4 54.3852 41.8501 0.825468 -5.0709 -17.7069 -2.05205 +412 4 0.696071 41.5065 41.5456 0.0730393 -4.82529 -32.9133 +413 4 0.904174 0.691668 0.985463 6.30616 -9.41897 -5.2369 +414 4 2.64269 40.3122 0.13166 16.7998 18.1471 15.5753 +415 4 3.13789 39.5289 1.58622 -1.56816 4.1145 9.56394 +416 4 3.29805 41.2779 1.59825 6.1243 20.9887 1.16769 +417 1 53.684 39.9214 3.65257 -36.1976 13.6917 8.19643 +418 2 52.3006 39.9493 4.06589 -56.8626 -17.5359 -10.0305 +419 2 52.042 40.5256 5.46425 9.62461 10.2848 -5.14962 +420 3 51.0331 41.2228 5.70144 14.4944 -11.372 -4.23176 +421 4 54.0189 39.0607 3.30247 15.8062 -40.5534 -6.95561 +422 4 51.6931 40.6476 3.38276 19.0563 -8.07776 7.22418 +423 2 51.5622 38.4976 3.96193 14.5706 2.1127 21.5154 +424 2 51.4158 37.9814 2.50572 24.752 -20.928 -15.9835 +425 2 51.0077 36.4305 2.37064 11.3099 30.9145 9.08043 +426 2 50.8522 35.9939 0.907307 -46.4939 -7.09254 -49.7464 +427 1 50.1475 34.7025 0.671588 69.6077 -32.405 2.84717 +428 4 50.6006 38.4842 4.55016 3.73478 6.81079 -18.2086 +429 4 52.1831 37.7463 4.55262 -3.81101 12.3643 -13.1539 +430 4 52.4118 38.1657 2.02278 1.77015 -18.5404 7.48984 +431 4 50.8584 38.5927 1.79489 -26.3581 9.74254 8.34414 +432 4 50.0453 36.2246 2.88499 -2.56193 3.57961 3.68626 +433 4 51.7703 35.8375 2.92238 0.215708 -6.73604 -5.33103 +434 4 51.7691 36.0437 0.240386 -6.2594 -4.10885 19.6388 +435 4 50.1039 36.686 0.3716 22.9763 1.60597 16.3794 +436 4 50.5914 33.8993 1.10828 2.95648 12.8391 18.7814 +437 4 50.3001 34.3737 41.6268 -19.3387 19.3411 -4.27099 +438 4 49.2006 34.6111 0.961468 -24.084 7.88088 -0.582308 +439 1 53.0235 40.2561 6.35237 -32.3128 10.4579 -5.0201 +440 2 53.1129 40.7256 7.70074 -41.6363 -1.15369 57.3167 +441 2 53.1798 0.352689 7.77253 -34.9991 -20.8035 37.2736 +442 3 52.5119 1.01286 8.63006 21.7579 -17.6925 -30.8538 +443 4 53.6931 39.5673 6.06584 22.7894 -18.2937 1.39271 +444 4 52.0865 40.4844 8.3065 35.7608 3.68212 -29.1988 +445 2 54.2701 40.0034 8.46069 6.08948 28.5921 -6.02695 +446 4 54.5971 40.5153 9.39975 -22.234 -14.34 10.1754 +447 4 0.201561 40.2092 7.93116 13.6903 -2.08726 -21.3806 +448 4 54.1655 38.8939 8.41526 -0.559105 0.118215 15.5404 +449 1 53.9752 0.884949 6.87383 32.3465 35.364 -24.1241 +450 2 54.062 2.35993 6.75215 -1.13821 -0.709889 -34.8218 +451 2 52.7471 3.02097 6.14186 4.92946 35.4069 59.7439 +452 3 52.3227 4.16587 6.4978 18.9545 -33.4145 3.00952 +453 4 54.7345 0.266534 6.4753 -18.8262 24.4346 -1.05702 +454 4 54.2802 2.76759 7.79054 -12.1814 3.84369 -14.3249 +455 2 0.185451 2.81859 5.73187 27.2059 46.9588 30.4236 +456 2 1.71808 2.36893 6.1571 -63.9259 -20.0653 -29.4315 +457 2 1.9764 2.63004 7.63437 43.6306 13.7343 2.97159 +458 2 3.27263 1.81187 8.04275 -33.9139 -3.58936 -6.58926 +459 1 3.78328 2.11956 9.34176 26.6398 21.4152 24.507 +460 4 0.173809 4.01773 5.82442 4.54198 -39.0295 -6.50933 +461 4 54.8792 2.64498 4.65574 11.0791 -10.5686 10.592 +462 4 2.43618 2.90609 5.45978 -2.35628 -10.1976 10.4282 +463 4 1.76796 1.2289 6.01344 4.57023 21.5888 -8.89179 +464 4 1.21473 2.41369 8.37281 -19.449 -19.8593 5.28327 +465 4 2.02309 3.72579 7.75906 18.9296 5.96095 -1.30777 +466 4 4.11389 1.88412 7.33652 2.51142 0.584915 -8.00636 +467 4 2.91513 0.727469 8.06593 14.1612 11.4678 0.952909 +468 4 3.87966 1.33238 9.93849 2.65093 -23.7146 9.43734 +469 4 3.29203 2.7681 9.89323 -42.3935 13.6729 9.41431 +470 4 4.65765 2.6209 9.4154 12.4458 -11.5538 -21.8273 +471 1 52.0387 2.32512 5.28273 -51.3661 -11.8477 -11.6622 +472 2 50.6641 2.72274 4.84157 25.7857 6.93126 13.1254 +473 2 49.5414 2.57609 5.91007 27.6149 -7.37739 5.45836 +474 3 48.7805 3.52104 6.09585 -8.9672 -1.93713 4.87304 +475 4 52.4681 1.55108 4.79165 6.19099 -18.5603 -5.58783 +476 4 50.6769 3.82983 4.70864 1.41274 -1.50214 -10.3294 +477 2 50.3587 2.05695 3.49156 -22.4167 -18.5545 -8.10533 +478 2 51.392 2.35646 2.3419 -24.5199 12.8001 2.40788 +479 2 48.9327 2.41504 2.97856 -9.14079 -2.86031 26.3031 +480 2 51.1945 1.4129 1.15651 29.522 -13.6455 -15.5517 +481 4 50.3189 0.937191 3.7523 9.08136 15.4094 -11.3523 +482 4 52.3823 2.12188 2.68097 31.5971 -0.36407 15.4796 +483 4 51.4014 3.46798 2.06765 -1.078 -19.9026 -0.0406259 +484 4 48.2117 2.12758 3.78451 -1.04241 22.2186 2.00084 +485 4 48.5813 1.67256 2.28636 2.21501 -12.0529 -35.8697 +486 4 48.7327 3.44552 2.54328 5.48386 -12.5705 11.3103 +487 4 52.1623 1.3706 0.452926 -36.5132 5.61179 20.4585 +488 4 50.2881 1.70969 0.600596 -1.11419 -0.409473 -10.6314 +489 4 51.0211 0.353877 1.53511 3.53067 13.7442 -8.50616 +490 1 49.5623 1.51743 6.77214 29.0905 -0.0770965 -25.5222 +491 2 48.7084 1.41716 7.91723 -3.12505 -21.6463 4.96918 +492 2 48.8549 2.61932 8.82546 31.903 20.2748 29.0475 +493 3 47.906 3.05048 9.46897 -16.8524 2.35798 -10.3438 +494 4 50.2118 0.710522 6.59294 -12.9921 18.0739 4.61122 +495 4 47.6425 1.393 7.52359 9.91609 0.328738 10.372 +496 2 49.0787 0.089334 8.73016 -60.0302 -9.6098 -44.8862 +497 2 48.2852 41.7441 10.0242 3.18066 15.7764 -9.96769 +498 2 46.7826 0.060746 9.96682 -2.34726 -14.6607 41.7592 +499 3 46.2233 0.511631 10.9878 -5.96974 4.10403 -23.4495 +500 1 46.1388 41.3329 8.97776 32.9533 20.065 15.0282 +501 4 50.1182 0.035639 8.93296 42.8084 2.68407 12.3764 +502 4 48.8904 41.1121 8.0025 3.88899 17.9501 19.4277 +503 4 48.6104 0.602172 10.7954 4.73737 -18.8132 -0.914642 +504 4 48.4759 40.6816 10.3394 0.165969 9.19265 10.3013 +505 4 46.673 40.8953 8.25882 14.2049 -15.3063 -26.5369 +506 4 45.1569 41.364 8.91958 -49.0994 -2.53611 0.320683 +507 1 50.1114 3.13932 9.06291 -28.12 32.8195 0.337886 +508 2 50.3404 4.32895 9.98795 -1.65029 -57.226 -17.8628 +509 2 50.0322 5.66893 9.41362 -36.2334 -9.83443 -38.9072 +510 3 49.3598 6.44562 10.1062 15.3309 6.40082 -5.38514 +511 4 50.9085 2.84633 8.5071 12.3092 -10.0263 -3.45928 +512 4 49.5835 4.28149 10.7848 -3.38143 -13.253 14.1405 +513 2 51.7461 4.22789 10.5468 25.7206 14.4209 20.1557 +514 2 51.9023 5.17188 11.7283 -67.9962 -1.36338 64.1829 +515 3 50.9364 5.19004 12.6002 28.9599 1.18541 -41.9912 +516 3 52.9319 5.83594 11.9785 18.8411 2.87417 -24.5577 +517 4 52.4276 4.5214 9.72474 12.6887 -3.13287 0.413374 +518 4 52.058 3.21563 10.9647 -9.24198 7.66389 -16.6414 +519 1 50.112 5.78532 8.03139 7.52033 29.602 25.459 +520 2 49.6799 7.08933 7.40639 14.3534 -30.8181 22.5674 +521 2 48.2409 7.17209 6.9711 -2.24553 44.7474 7.57528 +522 3 47.5844 8.22961 7.08968 18.1939 -9.81929 5.41459 +523 4 50.7064 5.09112 7.53173 -12.638 14.3936 -6.22521 +524 4 49.7159 7.84119 8.19837 -7.36252 7.51614 21.2329 +525 2 50.7023 7.64954 6.44039 -16.0213 -40.4967 -48.4302 +526 2 50.7257 6.82423 5.08423 -13.7427 47.9405 2.4816 +527 2 51.6418 7.28287 3.94021 29.8472 39.248 73.299 +528 2 53.127 6.98483 4.24688 1.29977 19.7271 -18.9866 +529 1 53.757 7.95176 5.17575 -11.1866 13.844 -62.5277 +530 4 51.636 7.68275 6.97838 28.3767 1.23741 1.58475 +531 4 50.4129 8.66535 6.18803 -0.179632 23.7408 -3.11047 +532 4 49.7187 7.01043 4.64523 -5.97611 -10.1095 1.48316 +533 4 50.8061 5.7562 5.2149 3.4405 -22.8364 10.0865 +534 4 51.5118 8.41472 3.72654 -1.36136 -26.6124 -3.74792 +535 4 51.4228 6.66542 3.12568 -20.7249 -22.8033 -58.4365 +536 4 53.6095 7.03345 3.2004 3.85152 5.93338 28.8514 +537 4 53.3314 5.96083 4.57939 -0.112253 -9.13532 8.29834 +538 4 53.309 8.86524 5.1699 0.162268 -2.42959 1.84412 +539 4 54.6672 8.17057 4.81193 19.2107 -0.812718 7.6593 +540 4 53.869 7.69009 6.11536 0.991087 -15.435 33.6166 +541 1 47.7293 6.1299 6.36528 -13.6545 -50.1986 -45.913 +542 2 46.4151 6.11998 5.73127 12.5517 -4.35851 26.1033 +543 2 45.4457 5.24236 6.50095 -54.5114 -4.35957 -22.3583 +544 3 44.2134 5.34166 6.22856 33.5613 3.36987 15.344 +545 4 48.2957 5.29705 6.08439 -4.65701 16.0313 11.2062 +546 4 46.0246 7.14829 5.83676 -12.413 4.85954 -1.2939 +547 2 46.3966 5.7006 4.23247 16.9743 -35.0719 19.3242 +548 2 46.8471 6.79722 3.31369 7.95245 13.9142 -51.9109 +549 2 46.0679 8.12855 3.29075 19.7668 12.2354 20.4517 +550 3 44.9703 8.28242 2.6836 -5.20426 -7.76074 -7.99938 +551 3 46.5716 9.08042 3.9624 -5.49585 -3.27174 -8.75295 +552 4 45.3525 5.37075 3.98324 7.30106 1.55378 -6.68576 +553 4 47.1483 4.79199 4.10624 -28.8106 21.423 0.303262 +554 4 47.0017 6.41037 2.24023 -12.0684 6.13088 18.9752 +555 4 47.8815 7.05675 3.60692 6.175 4.12296 2.89493 +556 1 45.8802 4.28795 7.34048 -32.7588 9.8199 -6.22093 +557 2 44.9801 3.41661 8.05582 7.11941 -0.762777 6.83491 +558 2 44.2841 2.32798 7.24802 57.2007 25.2815 -35.4523 +559 3 43.4338 1.62321 7.71908 -38.784 -24.7635 26.1598 +560 4 46.8556 4.13399 7.46211 34.7056 -9.13536 7.69054 +561 4 45.5867 2.90913 8.82837 -2.10841 -5.06197 5.41207 +562 4 44.2233 4.00883 8.63057 1.71074 -0.990438 -6.10924 +563 1 44.7516 2.08483 5.98824 -37.8462 -38.4135 -8.16449 +564 2 44.1597 1.01431 5.13579 -9.65639 -34.378 14.28 +565 2 44.8664 41.5016 5.49089 -11.1964 37.9598 3.64882 +566 3 46.103 41.4369 5.57345 -11.1149 2.47206 2.88353 +567 4 45.5262 2.474 5.47152 21.0389 22.2918 12.8005 +568 4 43.0172 0.862184 5.40503 31.5022 14.6416 -15.142 +569 2 44.4162 1.4085 3.60515 5.8653 -21.2021 14.2009 +570 2 43.5161 2.65984 3.27425 41.0117 -18.0627 24.5931 +571 2 44.2213 0.116838 2.67583 -30.001 3.65408 12.6342 +572 2 43.604 3.10049 1.82796 -41.0466 14.5447 22.3036 +573 4 45.4923 1.71966 3.57573 -0.138156 -3.02814 -11.6903 +574 4 43.8008 3.50537 3.97163 -2.46499 -4.10631 -11.566 +575 4 42.524 2.38704 3.60859 -29.3388 -0.685173 -5.23931 +576 4 44.5714 0.285197 1.65031 -2.2735 9.46305 -11.1841 +577 4 43.1006 41.7553 2.65834 21.2852 6.7215 -5.00379 +578 4 44.7366 41.0658 2.93547 0.768749 11.7185 9.28335 +579 4 44.5004 3.68719 1.60884 14.6444 -0.878149 -7.94907 +580 4 42.7371 3.8089 1.73084 7.8177 -0.664582 -10.9353 +581 4 43.3892 2.25631 1.16493 5.07933 -5.28874 -15.8541 +582 1 44.0858 40.4147 5.76991 -7.82686 10.7063 0.0613705 +583 2 44.6952 39.2248 6.26612 46.8291 -49.1328 2.55503 +584 2 45.6273 38.4983 5.15014 -10.8203 -24.5871 -10.3389 +585 3 45.1671 38.1033 4.04814 1.93862 22.6196 32.2907 +586 4 45.3114 39.4262 7.20071 -5.62912 7.00222 -16.0196 +587 2 43.5561 38.2867 6.74046 -22.632 -0.869913 -14.9675 +588 2 42.367 38.8131 5.80069 8.99216 14.1028 58.1483 +589 2 42.6345 40.3137 5.92605 0.476166 33.3948 28.8915 +590 4 43.357 38.4284 7.8368 -6.62566 13.9326 -12.0425 +591 4 43.8048 37.1922 6.7609 -3.60965 9.48681 -21.6917 +592 4 41.3136 38.6254 6.13023 8.266 -9.51845 1.65532 +593 4 42.4187 38.6156 4.74928 6.70678 -23.3061 -29.6074 +594 4 42.2773 40.816 6.98347 15.1971 -23.3227 -46.4987 +595 4 42.1119 40.8277 5.08767 -3.55372 4.4917 2.49103 +596 1 46.8487 37.9967 5.55394 17.2019 12.2692 25.006 +597 2 47.7247 37.0178 4.87762 -6.21972 -16.2302 -28.9734 +598 2 47.0354 35.8358 4.10675 -5.54108 30.4574 49.2069 +599 3 47.4638 35.4602 3.01706 -3.2731 6.26074 0.626287 +600 4 48.411 37.4477 4.12082 -11.0175 18.1135 -5.68521 +601 2 48.6499 36.5231 5.98749 -16.6595 -15.0747 15.7963 +602 2 48.891 37.7945 6.79307 0.637735 -25.9659 35.4869 +603 2 47.512 38.4108 6.81936 -6.06228 0.364124 -35.7901 +604 4 49.55 36.0027 5.64818 14.2665 0.926908 -8.4052 +605 4 48.1323 35.7432 6.6035 -1.04051 5.39171 0.916503 +606 4 49.6303 38.4539 6.33816 11.9938 9.28906 -4.17289 +607 4 49.2156 37.5316 7.87598 -0.828426 8.45001 -24.626 +608 4 47.6223 39.5002 6.92189 -5.61966 10.135 -2.25063 +609 4 46.9349 38.0418 7.65693 -11.0214 -6.34351 22.8142 +610 1 45.9811 35.3016 4.79343 19.1712 31.3513 11.165 +611 2 45.3118 34.1769 4.28537 -21.2148 -46.3229 -17.5718 +612 2 44.4751 34.4561 3.06273 -18.3812 8.00009 -33.6438 +613 3 44.391 33.6426 2.09905 3.94034 16.0457 30.0851 +614 4 45.6176 35.6832 5.71813 13.2063 -8.66839 -22.6288 +615 4 46.0373 33.4799 3.80083 11.0255 -0.404913 12.3267 +616 2 44.604 33.4055 5.40679 37.9095 -5.49339 -20.8443 +617 2 43.894 32.1911 4.95963 4.52806 -52.0805 -10.2655 +618 3 42.6666 32.0496 5.30411 26.1406 -7.63566 -17.5185 +619 3 44.6473 31.2926 4.419 -30.7677 19.4747 14.2469 +620 4 43.8381 33.9821 5.82617 -35.1808 40.951 30.2942 +621 4 45.3664 33.1691 6.19311 -10.275 -1.0365 4.4818 +622 1 43.9409 35.7078 2.94042 3.22733 -51.5357 -49.9186 +623 2 43.348 36.2006 1.70588 25.8776 -9.12573 -18.8138 +624 2 44.3757 36.8172 0.713167 -7.64912 -13.2689 38.6134 +625 3 44.0628 36.9589 41.4508 -2.41529 3.02373 -15.0868 +626 4 43.9087 36.323 3.69682 4.46748 41.5024 48.5675 +627 4 43.0059 35.3045 1.0879 -7.34341 13.0696 15.3539 +628 2 42.2218 37.2049 1.98307 -32.8685 -0.904888 11.5727 +629 2 41.1062 36.5938 2.90711 22.5622 20.6064 -2.77479 +630 2 39.8757 37.4913 2.92488 9.99264 -5.47282 62.3883 +631 3 39.5847 37.9927 4.02645 -6.88693 1.84466 -13.34 +632 1 39.0832 37.5519 1.86835 -2.09978 -20.426 -31.5908 +633 4 41.7044 37.4782 1.02484 10.2081 4.13789 1.30545 +634 4 42.5649 38.1527 2.49808 3.34998 -7.04672 -12.996 +635 4 41.496 36.4873 3.97615 -8.32458 2.86238 -16.0656 +636 4 40.817 35.592 2.59085 -6.50381 -15.3028 -7.15704 +637 4 39.3467 37.1489 0.943045 -1.18671 2.30285 11.2704 +638 4 38.1024 37.7997 2.00291 -4.61511 13.1634 -1.5169 +639 1 45.5865 37.1913 1.18701 0.34656 3.48246 -50.9957 +640 2 46.5715 37.7193 0.263736 40.0587 13.4866 27.3297 +641 2 47.1476 36.6709 41.2495 -9.99518 -39.8037 -22.9547 +642 3 47.6611 35.6473 41.7682 -3.12622 19.3551 -24.5438 +643 4 45.9505 37.0475 2.10099 0.0710674 -6.02767 36.3056 +644 4 46.0766 38.4733 41.5789 -9.05589 19.6465 -18.4972 +645 2 47.8462 38.4064 1.04164 -24.5048 14.2529 -26.5929 +646 2 47.4036 39.6651 1.82888 -3.7708 6.53308 31.1421 +647 2 48.5926 40.4064 2.51341 13.2626 3.99863 -2.76696 +648 3 49.7104 40.5691 1.98441 -24.6046 -10.5895 -1.86534 +649 1 48.3407 40.8898 3.74779 29.4138 -3.81739 16.8938 +650 4 48.597 38.7482 0.246377 -8.81496 -5.86425 14.2737 +651 4 48.3893 37.7509 1.72975 1.66752 -15.4435 3.74234 +652 4 46.6019 39.4971 2.66308 23.3117 -7.11271 -27.0857 +653 4 46.9261 40.3559 1.12913 -3.21242 13.4997 -7.95635 +654 4 47.3907 40.9351 4.12169 -5.60594 2.69026 7.41827 +655 4 49.1659 41.1473 4.37984 -25.8317 -2.18268 -20.985 +656 1 47.0143 36.8241 39.8589 2.94896 -6.17569 33.9376 +657 2 47.6738 36.0506 38.8108 16.6825 -23.5637 34.6067 +658 2 48.454 37.0258 37.9695 9.24498 -19.2444 17.2828 +659 3 47.9734 37.5867 37.0249 -16.9661 22.5794 -32.933 +660 4 46.3407 37.4883 39.4677 -2.13376 9.43233 0.449621 +661 4 48.4374 35.3321 39.3605 -24.6855 17.1776 -23.0678 +662 2 46.6968 35.2528 37.909 -27.9143 -33.2437 25.7199 +663 2 46.039 33.9895 38.7043 9.93401 10.5983 7.56799 +664 2 46.87 32.6784 38.9289 23.0786 -0.450758 -24.5995 +665 1 47.7656 32.5928 40.0651 -0.0346617 67.7235 50.2506 +666 2 48.5337 31.5574 40.3699 -14.5633 -26.8579 -35.9878 +667 1 48.7282 30.552 39.4879 -2.05986 8.25564 18.106 +668 1 48.8872 31.3858 41.6213 -4.84512 27.348 -3.11289 +669 4 47.2327 34.8627 37.0058 -5.81127 5.13112 -1.60937 +670 4 45.8267 35.9464 37.6192 18.3744 -10.9215 -5.83414 +671 4 45.065 33.6697 38.178 15.3305 12.1509 10.6411 +672 4 45.8045 34.3704 39.7428 -14.1926 -3.74807 -10.9265 +673 4 47.5159 32.4832 38.0006 -21.4463 1.51143 8.96621 +674 4 46.1858 31.8178 39.0967 -9.12823 -0.449275 -15.1225 +675 4 47.7485 33.3794 40.8208 -8.02877 -26.8637 -33.9869 +676 4 48.3609 30.5297 38.5261 -2.43008 2.66571 1.08755 +677 4 49.1746 29.6933 39.8011 5.57148 -11.3344 1.43527 +678 4 48.5595 32.0107 0.447997 -4.49593 6.14729 8.57279 +679 4 49.3675 30.5632 41.8859 20.5825 -37.41 17.1512 +680 1 49.6971 37.2567 38.3612 38.8031 36.8466 -19.9315 +681 2 50.6251 38.1764 37.6375 5.59701 -6.58181 11.8605 +682 2 51.1059 37.476 36.33 -5.39593 -3.52342 3.95062 +683 3 51.4567 36.2851 36.3473 -6.1727 9.88097 2.62067 +684 4 50.1666 36.6257 38.9842 10.5469 -17.0261 18.2142 +685 4 50.0436 39.1015 37.4003 1.48542 -2.85918 -9.88003 +686 2 51.8783 38.6033 38.5414 -14.1699 17.2606 4.5582 +687 2 51.4771 39.4948 39.8067 23.634 -8.13025 9.13717 +688 2 52.8025 39.6936 40.6861 -45.72 0.0787629 30.9804 +689 2 51.0312 40.8873 39.3543 -1.21924 6.71403 17.5275 +690 4 52.6247 39.2003 37.9187 -12.0326 -10.2321 5.24388 +691 4 52.4336 37.7304 38.9418 -1.83231 -8.6555 -7.07863 +692 4 50.6844 38.9864 40.4458 6.67436 6.37453 -9.78056 +693 4 52.9275 38.7652 41.2899 1.57503 4.15297 5.5095 +694 4 52.875 40.6185 41.4124 -9.95772 -27.9304 -22.9777 +695 4 53.6477 39.6981 40.0479 39.2622 9.27083 -23.1198 +696 4 51.882 41.4315 38.8764 -8.78739 -1.58992 -12.4168 +697 4 50.8284 41.5065 40.2813 -10.0843 -5.65437 -12.2377 +698 4 50.1041 40.7893 38.7156 9.84678 12.7352 4.22225 +699 1 51.1335 38.2092 35.1872 23.4477 43.7196 -18.1994 +700 2 51.5372 37.7272 33.8205 5.66277 23.826 53.2621 +701 2 52.816 38.5373 33.39 -13.9696 27.2523 3.91394 +702 3 52.9014 39.7954 33.5824 -9.48934 -35.8428 -1.88315 +703 4 51.0917 39.2914 35.1751 -6.07189 -44.7564 8.7296 +704 4 51.807 36.6734 33.9114 3.67702 -17.8942 -3.77347 +705 2 50.2728 37.942 32.9627 24.5619 2.20768 -27.072 +706 2 49.0946 37.0552 33.3907 -40.4332 32.861 4.12747 +707 2 50.6582 37.6771 31.4819 -4.87136 -12.6088 -15.1928 +708 2 49.1924 35.592 33.2496 18.605 -47.1891 -10.6734 +709 4 50.0222 39.0181 33.0462 -10.0421 3.96713 0.824793 +710 4 48.1822 37.369 32.7965 11.3859 0.507389 5.43773 +711 4 48.766 37.227 34.4352 6.35082 10.8857 5.72377 +712 4 49.7261 37.457 30.8365 21.3715 9.42576 10.5226 +713 4 51.3528 36.7896 31.3856 -11.4398 6.26312 1.5823 +714 4 51.2274 38.5516 31.0485 -10.0605 -6.0953 1.35419 +715 4 50.1827 35.2313 33.6939 -19.2762 -1.86106 -7.31237 +716 4 49.1345 35.3223 32.1629 6.46074 -3.78635 4.92713 +717 4 48.3248 35.0641 33.7333 8.66481 1.90115 0.669024 +718 1 53.7674 37.8522 32.7049 -0.401058 29.0536 2.76503 +719 2 54.8534 38.494 31.9889 21.3589 25.2573 -50.7784 +720 2 0.070256 37.9331 30.5159 -12.6617 -10.513 26.1463 +721 3 0.610536 36.8336 30.3273 -13.153 9.14635 -3.0322 +722 4 53.7049 36.8532 32.6778 5.78014 -33.2974 -6.55066 +723 4 54.4976 39.583 31.7137 12.734 -24.0185 30.659 +724 2 1.32523 38.4582 32.6174 -11.2306 -14.0383 43.8112 +725 2 2.25298 39.4244 31.93 21.239 -3.52493 -6.53852 +726 2 1.82142 40.7594 31.946 9.01925 8.15494 1.3639 +727 2 3.55305 39.1373 31.3858 -52.1121 -37.4601 32.7366 +728 2 2.62719 41.7738 31.436 16.1375 42.966 -9.20235 +729 2 4.2717 40.1621 30.8907 55.019 31.5071 -38.7093 +730 2 3.8753 41.5182 30.8618 10.3374 -30.1635 6.5347 +731 4 1.72137 37.3957 32.6071 -2.968 13.2806 -7.3675 +732 4 1.36361 38.7573 33.7485 -10.0277 -6.08615 -32.1159 +733 4 0.900203 41.04 32.4671 -4.90014 4.47018 0.827909 +734 4 4.05865 38.1292 31.3848 -19.507 10.3261 2.47632 +735 4 2.40669 0.963664 31.507 -12.4107 -17.8541 2.52862 +736 4 5.22734 39.8163 30.4261 -2.17835 18.3508 4.41679 +737 4 4.61313 0.382875 30.4956 -18.9116 -9.53382 4.9162 +738 1 54.5208 38.7001 29.536 -17.794 9.59417 2.44526 +739 2 54.4433 38.3677 28.0932 0.413701 6.77287 11.8816 +740 2 53.8236 36.9714 27.8054 -10.5704 38.9519 24.3324 +741 3 54.2836 36.1684 27.0139 12.3723 -16.7122 -9.38408 +742 4 54.0063 39.582 29.8758 15.9225 -27.1932 -25.0825 +743 4 53.6617 39.0994 27.7122 21.1252 -9.31914 -10.5745 +744 2 0.84771 38.4562 27.3872 5.21129 26.4327 0.415045 +745 4 1.55752 39.2926 27.6564 -22.375 -0.429945 3.27523 +746 4 0.737328 38.5366 26.268 -0.662808 -7.52676 8.67249 +747 4 1.44048 37.5755 27.6711 3.3074 -14.1434 -6.0421 +748 1 52.6712 36.7812 28.4639 -34.4859 10.4254 42.9936 +749 2 51.8461 35.5981 28.5315 7.11639 -32.3641 19.2856 +750 2 52.1287 34.6607 29.761 72.1729 37.4894 -16.6197 +751 3 51.2969 33.8912 30.1393 -37.38 -39.1809 16.7772 +752 4 52.2301 37.5459 29.0797 18.7619 -22.9106 -24.882 +753 4 50.752 35.8045 28.6381 6.6344 10.4547 -3.03351 +754 4 51.9318 34.9661 27.6028 3.27123 7.03186 8.45077 +755 1 53.4041 34.6064 30.3039 -37.1524 -18.2668 23.7743 +756 2 53.8481 33.579 31.3343 19.9058 12.4048 -28.9308 +757 2 53.2753 33.7631 32.7245 -4.20442 17.2631 -10.7202 +758 3 53.3264 34.8931 33.2388 -7.00143 -11.8952 2.65621 +759 4 53.9984 35.4233 30.2821 14.046 11.4873 -9.55867 +760 4 53.5575 32.5679 30.9796 -2.97426 -3.20006 -4.3618 +761 2 0.441949 33.6673 31.397 15.483 24.485 -22.5221 +762 2 1.1159 33.1056 30.111 -2.52249 -22.0361 -11.2405 +763 2 2.65939 33.3504 30.0471 -29.7948 -11.8394 -36.8606 +764 2 3.5253 32.433 30.8659 3.71436 3.74322 35.9681 +765 1 4.92891 32.7835 30.8601 -3.73949 -14.6782 3.94495 +766 4 0.930008 33.1164 32.2052 -10.1795 -8.12889 21.2637 +767 4 0.820281 34.7554 31.5264 -17.1946 -20.5931 1.67355 +768 4 0.726808 33.5631 29.1693 -8.69229 5.5421 6.41341 +769 4 0.816642 32.0044 30.0112 14.0154 14.8269 0.94841 +770 4 2.76655 34.4177 30.2798 16.9839 11.3836 1.64388 +771 4 2.99027 33.2006 28.9712 -4.31169 8.16855 10.4317 +772 4 3.48024 31.3628 30.6286 -9.21502 -9.13385 -9.88849 +773 4 3.14214 32.5157 31.9169 10.307 -3.37241 -3.01155 +774 4 5.38024 32.7641 29.968 4.13535 -6.65161 -12.8027 +775 4 5.44585 32.16 31.4735 7.57437 4.94374 1.68638 +776 4 5.11721 33.7072 31.1652 -0.520286 24.3887 13.7994 +777 1 52.7286 32.6609 33.3217 21.3895 7.82715 -40.48 +778 2 52.3746 32.6765 34.6845 -3.94215 -5.7204 42.1903 +779 2 53.6544 32.9612 35.4718 -32.0777 16.7216 -3.31611 +780 3 54.7101 32.4293 35.2196 26.5529 -12.799 -1.69002 +781 4 52.7346 31.7402 32.8358 -3.66087 10.5856 2.03104 +782 4 51.6553 33.4893 34.886 -4.93781 11.2662 -7.45083 +783 2 51.7389 31.3462 35.1425 36.1525 -8.24878 -2.45066 +784 2 50.4549 31.4357 35.902 -2.56298 9.46411 57.003 +785 2 50.5914 31.9702 37.3969 -4.77582 -10.2539 -35.2763 +786 3 49.9129 32.941 37.7385 4.53321 10.1718 7.36032 +787 1 51.4448 31.3274 38.2318 1.89331 10.2207 20.9211 +788 4 52.4532 30.7011 35.7138 0.934865 4.72627 -2.3237 +789 4 51.5619 30.7887 34.2312 -11.1921 -21.1455 -14.7508 +790 4 50.0197 30.4197 36.0127 -8.03636 -0.273264 -6.56567 +791 4 49.7685 32.1089 35.3545 -11.9583 -2.57651 0.31815 +792 4 51.7323 30.3416 38.1022 2.22495 5.18328 -8.30147 +793 4 51.645 31.7871 39.1631 -4.2657 -12.8631 -21.1898 +794 1 53.54 33.8952 36.4131 -39.2018 -0.531466 -0.79929 +795 2 54.5682 34.2648 37.3102 -29.3437 58.7358 21.9421 +796 2 54.3255 33.5954 38.6431 29.6978 -77.406 0.637438 +797 3 53.3742 33.7807 39.3881 -15.8118 22.9548 5.85491 +798 4 52.6165 34.3686 36.5483 14.9252 -1.63515 2.31459 +799 4 0.525104 33.9954 36.8979 32.3496 -27.0675 -4.05845 +800 2 54.6285 35.827 37.4074 -17.7645 -17.3983 39.0191 +801 2 0.013954 36.4546 36.058 15.6745 -1.04323 18.583 +802 2 0.049019 37.9526 36.293 -63.1087 6.90888 -39.4544 +803 2 1.42802 35.9308 35.6826 4.08802 -6.56861 34.108 +804 4 0.435555 35.9801 38.2063 -13.4425 16.5914 -13.2273 +805 4 53.6198 36.2963 37.798 28.292 -21.2068 -7.80607 +806 4 54.2061 36.2134 35.3084 7.36084 -1.04605 -3.46995 +807 4 54.0713 38.2397 36.8522 27.1057 4.55429 -9.55418 +808 4 54.939 38.4282 35.2643 6.0019 1.58695 18.2366 +809 4 0.927863 38.3313 36.762 28.685 14.2218 21.5028 +810 4 1.30489 34.8989 35.3991 1.43296 -22.664 -21.4406 +811 4 2.25694 35.8344 36.4845 -24.5016 17.8738 -12.6534 +812 4 1.83634 36.4362 34.8335 13.635 15.7788 -26.8996 +813 1 0.008587 32.3758 38.733 13.7846 27.3237 -75.0314 +814 2 54.826 31.3 39.6331 17.4428 -14.6066 45.4768 +815 2 0.455793 31.7866 40.9725 -5.37526 1.66294 14.9859 +816 3 1.60943 32.1773 41.0547 11.2247 3.92934 -7.13086 +817 4 0.661532 32.0877 37.9163 -19.8505 19.9989 33.4434 +818 4 53.7452 31.1425 39.875 0.374502 -5.35979 -15.722 +819 2 0.574437 30.0043 39.0439 11.2157 23.6116 11.9724 +820 2 0.334302 28.7136 39.8578 -22.6665 -11.1233 -21.4622 +821 2 0.695999 28.7 41.3625 12.0844 -36.9796 9.0265 +822 3 54.7253 28.727 0.298109 10.889 15.3071 -4.11946 +823 3 1.91063 28.4506 41.7261 -30.7481 15.8042 -10.4483 +824 4 1.71086 30.1341 39.082 -19.7243 9.32222 0.312381 +825 4 0.358791 29.9926 37.9166 -2.62684 -19.8589 21.79 +826 4 0.882365 27.912 39.2891 -0.232785 0.308618 14.1734 +827 4 54.2301 28.3798 39.7718 17.2545 10.1943 -0.206185 +828 1 54.6325 31.7916 0.156881 38.5875 2.07504 -29.8841 +829 2 54.8631 32.3302 1.45975 7.41407 33.4343 26.7616 +830 2 1.21087 32.0241 2.20189 -33.1211 2.89979 -4.9396 +831 3 1.57835 32.811 3.08735 12.0797 -3.2377 -11.0832 +832 4 53.6756 31.6317 41.8616 -38.5912 -7.03962 0.740029 +833 4 54.9627 33.4927 1.3754 -11.7864 -35.033 -4.32612 +834 2 53.6666 32.0355 2.42828 -17.6969 8.95863 -1.18459 +835 2 52.1933 32.3158 2.0402 15.1012 41.0915 -15.9482 +836 3 51.3911 33.0513 2.74715 36.5037 -34.5123 -13.5772 +837 3 51.9207 32.0348 0.835441 -22.1157 -3.97518 6.29873 +838 4 53.9089 32.5595 3.33158 -2.01457 20.6007 30.7692 +839 4 53.6609 31.0051 2.75768 6.68313 -26.6133 3.27231 +840 1 1.77413 30.8239 1.99288 23.346 -11.0551 12.4557 +841 2 2.99412 30.3649 2.70859 20.7873 20.7026 2.58588 +842 2 4.37767 30.5585 1.9432 -4.58172 12.4342 76.2013 +843 3 5.43315 30.6356 2.6242 -17.4542 -1.84538 -14.1099 +844 4 1.23141 30.1158 1.49013 8.16278 -4.42375 -5.05013 +845 4 3.08709 30.9756 3.71749 -2.54673 -19.312 -31.0286 +846 4 2.99418 29.2776 2.99437 -11.6108 14.2547 -3.21828 +847 1 4.33484 30.73 0.643592 -44.4777 10.1896 -41.2897 +848 2 5.29878 31.2923 41.6537 25.3276 0.744315 3.96016 +849 2 5.54544 32.7486 0.121481 37.2819 -30.872 -27.7426 +850 3 4.68176 33.387 0.67546 -18.5336 28.2868 17.8008 +851 4 3.3891 30.7154 0.224796 5.58966 -1.49205 -0.51948 +852 4 6.30256 30.8588 41.8823 -3.47112 -15.4387 -8.82901 +853 2 4.8423 31.1802 40.1578 47.5835 -21.6785 -9.15502 +854 2 4.71332 29.7742 39.4637 -7.18766 34.2596 -8.85866 +855 2 5.63064 28.6968 40.0034 1.34917 -52.5839 -25.1875 +856 1 5.28494 28.1736 41.3081 -3.70672 3.58414 23.7744 +857 2 6.07557 28.0057 0.492928 -10.4577 4.69864 -29.3733 +858 1 7.37832 28.2278 0.392183 22.9004 -4.79637 26.256 +859 1 5.53705 27.6868 1.66636 -6.4094 -24.443 39.9026 +860 4 5.53303 31.787 39.5095 -0.196101 -2.7377 7.98036 +861 4 3.92152 31.7024 40.0755 -40.4143 20.5365 -6.7059 +862 4 4.89215 29.8961 38.3273 -2.53464 -0.592337 23.8175 +863 4 3.64677 29.4833 39.5295 -2.27017 -8.63927 2.61329 +864 4 6.69627 28.939 39.9328 9.42975 10.3347 -2.35439 +865 4 5.48992 27.7969 39.2806 7.04825 21.6687 20.0754 +866 4 4.27254 28.0467 41.4152 -4.83075 -3.28587 3.65899 +867 4 7.98538 28.2099 41.4852 -8.02405 3.18538 -21.0185 +868 4 7.94047 28.2423 1.24565 0.364194 -0.98827 11.7246 +869 4 4.53186 27.4078 1.78766 14.7644 10.3007 -8.4097 +870 4 6.1013 27.52 2.55737 -8.44391 7.70178 -27.0297 +871 1 6.79596 33.2006 41.6804 -27.9344 8.59735 4.57792 +872 2 7.15148 34.5952 41.8655 -38.9276 -12.1291 -1.68573 +873 2 6.77215 35.2911 40.5652 14.0197 56.9428 51.8707 +874 3 6.49158 34.715 39.5569 -13.5951 -21.5425 -43.0675 +875 4 7.31858 32.7386 40.9072 -2.655 4.76346 14.1821 +876 4 6.52583 35.0505 0.829338 19.3934 -10.3795 -24.0216 +877 2 8.63545 34.7883 0.159249 -4.7809 22.3707 74.7553 +878 3 9.31911 34.1951 41.0459 32.4158 -10.9375 -20.7672 +879 2 9.12239 34.1481 1.54228 -45.3508 12.3646 -39.5443 +880 4 8.86138 35.9031 0.177513 1.59938 -13.4643 1.18346 +881 4 10.1943 34.4871 41.2598 15.0836 -7.29109 -20.5697 +882 4 10.1218 34.4779 1.7295 32.9793 8.82002 13.7556 +883 4 9.1354 33.0404 1.45915 -3.89828 -1.77159 7.54964 +884 4 8.44695 34.5279 2.36236 9.39315 -9.78399 0.0431608 +885 1 6.96309 36.6454 40.6555 -22.2962 -38.3404 -33.8498 +886 2 6.94214 37.5275 39.5132 -15.3576 22.9899 27.1878 +887 2 8.03225 37.1821 38.5547 25.8315 2.87875 -39.3086 +888 3 7.87409 37.2091 37.3037 -11.7489 -2.94068 30.2829 +889 4 7.09017 37.0079 41.5812 4.58243 22.402 24.7274 +890 4 6.01646 37.4072 38.9238 -6.0018 -8.28766 -1.15408 +891 2 7.01182 39.0163 40.0252 -15.3603 -23.3284 55.3652 +892 2 5.61926 39.5384 40.7634 13.0639 11.727 -14.3013 +893 2 5.74741 41.0778 41.0735 34.612 -8.65688 -61.1535 +894 2 4.30485 39.278 39.9775 33.2171 6.29002 -24.4772 +895 4 7.23253 39.6079 39.1676 9.01238 29.648 -28.6912 +896 4 7.91826 39.1206 40.7867 -28.368 0.120823 -25.2036 +897 4 5.4532 38.9933 41.7239 13.5286 -1.18368 4.70417 +898 4 4.88701 41.4539 41.5866 -22.2749 9.39049 21.0562 +899 4 5.89633 41.7578 40.1185 -8.19165 -26.548 25.276 +900 4 6.67066 41.2365 41.6556 -0.494064 4.57358 11.7906 +901 4 4.18164 39.8273 38.9933 8.48456 -7.17755 11.4037 +902 4 3.44244 39.5261 40.5797 -17.807 1.17877 7.97341 +903 4 4.2824 38.1939 39.7929 -10.4691 -3.8299 -8.01616 +904 1 9.23783 36.8543 39.0653 -4.40645 21.0053 19.4908 +905 2 10.3275 36.5838 38.1582 31.0816 -25.3995 62.8998 +906 2 10.2997 35.2224 37.4613 6.04581 38.1949 -0.210763 +907 3 11.0208 35.1071 36.4655 -6.3656 -14.3958 -11.0193 +908 4 9.51333 37.1441 40.0706 -14.9717 -14.5173 -38.8343 +909 4 10.386 37.3498 37.3821 -1.67567 12.3369 -13.0834 +910 2 11.6168 36.6846 39.0604 -5.3878 -32.5356 -23.0633 +911 3 11.6818 35.7254 40.0985 -18.2206 13.507 16.8431 +912 4 11.7318 37.6647 39.5052 6.99822 20.9023 2.76215 +913 4 12.4798 36.426 38.4299 12.1644 16.7594 -11.1747 +914 4 12.2479 35.0511 39.7675 10.0745 -20.8981 -3.76732 +915 1 9.3909 34.3264 37.8733 -42.427 -15.3638 26.6935 +916 2 8.99216 33.1557 37.0842 54.1918 17.4661 1.85655 +917 2 8.44195 33.5842 35.7305 -20.833 60.571 55.2199 +918 3 8.45395 32.8337 34.8033 7.91235 -41.3122 -40.5547 +919 4 8.901 34.4208 38.8182 18.72 -3.57692 -25.7233 +920 4 10.0039 32.69 36.8915 -15.1884 -12.4868 -9.34361 +921 2 8.05349 32.1507 37.7268 -1.844 -26.1592 7.76215 +922 2 8.63612 31.2276 38.7905 8.98886 15.2457 3.52798 +923 3 8.28567 31.4376 39.9878 9.18033 -14.5703 -9.08999 +924 3 9.46172 30.3301 38.4185 -14.4281 10.7169 -2.66077 +925 4 7.57008 31.4717 36.9797 -4.32683 11.3708 2.99534 +926 4 7.24557 32.7088 38.1955 -18.7592 7.98312 4.87833 +927 1 7.76821 34.7903 35.7104 -0.921577 -49.5867 -7.77983 +928 2 7.00589 35.2713 34.5947 28.4194 33.7396 -49.4054 +929 2 7.85162 36.3274 33.7967 14.0615 10.3677 50.876 +930 3 7.59561 36.677 32.642 -11.5138 -12.0529 -0.0837023 +931 4 7.64044 35.3156 36.5601 -2.79577 12.0246 16.4277 +932 4 6.95142 34.464 33.8059 -8.74679 1.13416 10.6726 +933 2 5.60472 35.8897 34.9384 -10.82 -34.5279 -29.2679 +934 2 4.80808 34.6511 35.4252 21.4048 19.1212 -24.4535 +935 2 4.58939 34.449 36.7896 -8.79739 7.49237 6.99756 +936 2 4.44707 33.6361 34.4808 -22.1156 13.6667 13.0483 +937 2 3.78406 33.375 37.155 10.056 16.8174 60.0349 +938 2 3.57928 32.5992 34.8543 35.6828 20.067 14.4288 +939 2 3.32606 32.5122 36.2195 -36.4887 -32.5961 -12.2866 +940 3 2.43989 31.6229 36.7148 -5.7594 -17.052 -20.0699 +941 4 5.14192 36.3424 33.9886 5.39246 -18.3577 14.2305 +942 4 5.60606 36.7583 35.5989 7.01287 1.52307 19.367 +943 4 4.94491 35.1783 37.5598 -4.47364 -7.92921 -7.91861 +944 4 4.66046 33.7427 33.4202 4.87397 4.4658 -8.40916 +945 4 3.45738 33.1597 38.2449 15.2806 17.1295 -26.8514 +946 4 3.26795 31.828 34.148 -6.61111 -3.61155 -4.72788 +947 4 2.1868 31.1622 35.9134 -6.91994 -9.03483 11.406 +948 1 8.90205 36.8981 34.5027 -17.2687 17.5401 -60.9896 +949 2 9.70361 38.0134 33.9387 24.2231 -52.0812 37.3823 +950 2 8.8546 39.1711 33.5701 14.7092 18.0593 -4.53516 +951 3 9.06515 39.7643 32.526 6.45085 3.58457 -7.26619 +952 4 9.11675 36.6435 35.4518 3.62665 -3.0608 21.1339 +953 4 10.3861 38.3235 34.818 -10.2978 3.44266 -21.7419 +954 2 10.5787 37.5562 32.7307 -21.6135 -30.8037 4.74181 +955 2 11.6892 38.5091 32.4223 15.379 -13.1594 38.9153 +956 3 11.683 39.1804 31.4042 4.19267 20.0472 -18.4805 +957 1 12.6852 38.53 33.3751 41.3863 26.0224 -13.8263 +958 4 9.85905 37.4261 31.8504 20.0453 2.40541 7.8736 +959 4 11.053 36.5467 32.9319 -7.17885 8.97611 -4.2567 +960 4 12.817 37.8369 34.166 -15.4043 12.1891 -16.4176 +961 4 13.5001 39.2408 33.2564 -39.0039 -25.8302 4.81098 +962 1 7.96197 39.5631 34.4599 -33.9246 23.5433 37.1278 +963 2 7.21007 40.8276 34.5568 -18.3646 -15.2096 -14.7898 +964 2 8.22007 41.896 34.9201 0.758716 14.3361 -6.26955 +965 3 8.97663 41.7874 35.871 13.0919 -8.40756 13.8683 +966 4 7.83943 39.0508 35.3409 8.95409 -9.59767 0.690263 +967 4 6.70734 41.0591 33.5261 17.9743 -2.28149 22.8597 +968 2 6.0301 40.6247 35.6674 21.3841 11.5647 -11.8815 +969 2 4.89974 39.9794 34.8247 17.8968 2.41192 -27.2216 +970 2 5.64567 41.9074 36.4174 -5.31946 16.9228 -22.0167 +971 2 3.85064 39.271 35.6143 -7.9417 -14.8054 48.1955 +972 4 6.41951 40.0018 36.4929 2.02391 -20.04 -2.41117 +973 4 5.36435 39.2019 34.126 -8.73918 7.93575 11.5905 +974 4 4.48342 40.7424 34.1094 -6.00744 -5.42447 8.5897 +975 4 5.00487 41.8434 37.3074 -11.5574 -14.3762 1.01334 +976 4 5.12929 0.689353 35.6946 7.17582 1.37977 8.89479 +977 4 6.56067 0.460605 36.8355 2.18467 8.54142 -3.2903 +978 4 3.23423 39.9796 36.2601 8.91814 -10.815 -11.4927 +979 4 4.38489 38.5352 36.333 -17.3309 14.265 -14.1697 +980 4 3.16246 38.6765 34.9814 -1.3822 0.0882741 -1.23744 +981 1 8.27901 1.09677 34.1745 -17.8694 -35.8502 15.8719 +982 2 9.1495 2.17731 34.4611 25.5007 24.1899 -15.5427 +983 2 8.44305 3.45517 34.8181 7.33507 13.3767 -14.0082 +984 3 7.22584 3.58853 34.5952 14.73 6.44535 13.4701 +985 4 7.64387 1.07834 33.3925 -5.10967 17.8437 -25.4682 +986 4 9.72616 1.98981 35.3795 6.67437 -11.367 8.50474 +987 2 10.1416 2.3939 33.2727 7.80857 1.28792 -5.65283 +988 2 11.1754 1.27875 33.0535 -29.5709 -1.62172 8.74553 +989 2 12.298 1.25902 34.0434 45.8123 -20.4226 -15.8942 +990 3 13.4264 1.60062 33.6211 -9.09849 2.20405 14.6225 +991 1 12.1286 0.499484 35.1615 13.5856 38.0862 1.93866 +992 4 10.7117 3.33658 33.4062 0.0269402 1.80508 0.780117 +993 4 9.62868 2.54332 32.3022 -11.3844 1.67988 3.84081 +994 4 11.6026 1.39089 32.0291 1.1132 -6.32648 1.88738 +995 4 10.6463 0.304077 33.1517 4.80745 -4.48978 -13.057 +996 4 11.1623 0.324257 35.4356 -7.1112 -9.24345 12.7946 +997 4 12.86 0.645961 35.8984 -11.3978 -13.87 -11.7385 +998 1 9.29061 4.442 35.2624 -22.3208 40.9019 24.8252 +999 2 8.81116 5.82611 35.6978 -18.3987 -9.60009 -41.1421 +1000 2 7.90959 6.36535 34.5148 35.1086 -14.4229 -13.6713 +1001 3 8.27789 6.14754 33.3333 -13.6173 9.04219 21.6414 +1002 4 10.326 4.35425 35.3433 -15.5473 -10.8229 -5.10085 +1003 4 8.07437 5.70026 36.5174 9.02025 -1.47766 10.124 +1004 2 9.99583 6.76313 36.1565 -25.1565 20.6308 -28.9867 +1005 2 11.135 6.93617 35.1361 2.62363 -10.5046 6.46017 +1006 2 12.4502 7.42969 35.8581 -25.4448 -27.2564 -27.4451 +1007 2 12.3858 8.85842 36.3442 -55.084 26.5775 24.6628 +1008 1 13.634 9.41318 36.7712 33.8844 -44.8334 11.878 +1009 4 10.2929 6.30703 37.0832 24.0012 -1.96783 25.2264 +1010 4 9.73373 7.84957 36.4159 -14.1304 -26.7275 0.147522 +1011 4 10.8081 7.68154 34.3572 5.16283 -4.02502 4.78839 +1012 4 11.298 5.9636 34.5725 5.23915 16.0099 8.41141 +1013 4 13.159 7.4137 35.035 25.5516 -2.14082 -10.0364 +1014 4 12.8083 6.68649 36.6117 -1.06896 6.08822 -0.205097 +1015 4 11.642 8.94716 37.2538 22.1051 -1.45756 -27.4817 +1016 4 11.9592 9.50431 35.5025 9.97141 -3.64215 15.7788 +1017 4 13.6538 10.3723 37.0555 -8.09423 13.3796 3.79584 +1018 4 14.2885 9.3339 36.0056 2.60625 13.8446 -5.44478 +1019 4 14.0928 8.83644 37.5176 -15.06 24.3666 -13.6607 +1020 1 6.73429 6.959 34.8261 9.36917 -0.537504 -3.37326 +1021 2 5.68914 7.48312 33.9811 -11.6093 0.198368 -29.7566 +1022 2 4.72257 6.43001 33.3633 23.9678 57.8121 29.6097 +1023 3 3.69345 6.80336 32.8731 -41.5354 18.269 -25.9458 +1024 4 6.5403 7.08067 35.8075 -8.4584 6.57489 23.7637 +1025 4 4.95828 8.08289 34.6274 18.5559 -1.63885 -10.0577 +1026 2 6.30301 8.33887 32.7628 1.61604 -0.894199 46.3222 +1027 2 6.96232 9.68302 33.2113 17.5203 -12.0258 -13.4607 +1028 2 6.11334 10.8061 33.8152 -7.60378 12.6352 19.0416 +1029 3 5.31496 11.4419 33.0422 10.0378 -5.26853 5.86857 +1030 3 6.28181 11.1536 35.05 3.36103 -18.7342 -31.8229 +1031 4 5.5011 8.60814 32.0808 -13.4162 -1.3456 -15.0867 +1032 4 7.01778 7.64283 32.2215 -8.51236 18.4517 -1.11608 +1033 4 7.483 10.1113 32.3225 -5.01151 2.49106 -4.14977 +1034 4 7.84021 9.44334 33.8428 -3.17944 -2.15711 8.7111 +1035 1 4.98957 5.17145 33.408 31.7294 -73.5208 5.3031 +1036 2 4.03057 4.12888 32.9492 20.6717 -14.7005 -20.2168 +1037 2 2.6598 4.36206 33.592 -3.0444 -3.65398 -36.823 +1038 3 2.63368 4.6245 34.7729 -17.9957 9.5377 28.5993 +1039 4 5.93287 4.88555 33.7778 -25.4301 -4.21673 -10.3446 +1040 4 3.97065 4.08898 31.7849 -0.621936 10.7688 28.6704 +1041 2 4.54797 2.73693 33.4323 -9.78314 13.2989 35.3654 +1042 3 5.7396 2.38581 32.8061 3.87836 -1.00687 -28.9834 +1043 4 3.83029 1.94659 33.1597 -9.96533 -6.0451 7.8725 +1044 4 4.7579 2.77573 34.5879 -14.8326 -6.64015 -28.538 +1045 4 6.39905 2.57303 33.4496 16.1931 5.10903 8.49462 +1046 1 1.55493 4.20465 32.7937 9.73391 7.12296 -2.26043 +1047 2 0.143907 4.28394 33.2313 13.768 -18.1657 13.0528 +1048 2 54.6863 2.83094 33.3214 -0.0746788 -18.1404 42.9803 +1049 3 54.7972 2.04898 32.3833 -5.36381 -6.57018 -20.4337 +1050 4 1.75536 3.84626 31.8337 -17.5999 5.97734 12.9737 +1051 4 0.145346 4.72929 34.2869 -5.52407 -1.41906 -16.7638 +1052 2 54.0936 4.99047 32.3072 48.5491 53.4262 27.9832 +1053 3 54.4431 6.39026 32.3568 26.5828 -36.1107 8.98461 +1054 2 52.7233 5.01429 32.8691 -55.1486 3.23885 2.70228 +1055 4 54.1505 4.66496 31.2868 0.0550865 -16.0071 -29.7017 +1056 4 53.7986 6.85268 31.88 -20.6445 25.8891 -20.893 +1057 4 52.6197 5.54793 33.8322 5.93951 -5.3567 9.34144 +1058 4 52.3467 3.98503 32.9647 -9.06602 -5.34833 4.63236 +1059 4 51.9747 5.55452 32.2255 9.49609 -7.51028 -3.22615 +1060 1 54.1802 2.39741 34.5222 -14.8232 32.9081 27.5353 +1061 2 53.4465 1.14651 34.785 33.9277 15.1 -62.0226 +1062 2 52 1.44639 34.4384 -40.9452 -8.29472 -14.3346 +1063 3 51.516 2.52365 34.8247 -1.26544 -9.47139 -8.9244 +1064 4 54.0715 3.07846 35.3501 9.6448 -17.4772 -31.2652 +1065 4 53.9076 0.391021 34.1043 -10.2836 -7.20705 -0.475865 +1066 2 53.6069 0.737389 36.2058 40.6624 3.41232 47.0409 +1067 2 0.15698 0.778637 36.8849 -22.9225 14.5477 7.59965 +1068 2 0.184063 0.045177 38.2545 -1.48959 -18.0819 6.68284 +1069 2 1.19764 0.213126 35.924 -17.0247 17.4527 -16.4279 +1070 4 53.1759 41.6554 36.3315 -4.28574 -19.6707 2.88188 +1071 4 52.9166 1.40322 36.7387 0.80484 4.57892 22.2756 +1072 4 0.570353 1.84035 37.1024 -27.1105 -11.6335 -5.02718 +1073 4 54.3756 0.329349 38.9832 1.77724 8.98271 -8.45905 +1074 4 1.16626 0.241414 38.7954 -11.8595 -7.79047 -8.4361 +1075 4 0.0237 40.841 38.1265 8.8292 11.305 -0.869273 +1076 4 2.1582 0.044818 36.439 11.171 3.86438 -4.7836 +1077 4 1.22244 1.0066 35.1406 25.1303 -1.4606 -0.0516333 +1078 4 0.965216 41.2564 35.3038 -8.75588 -20.9773 6.66787 +1079 1 51.2089 0.49816 33.7614 57.6433 8.13256 28.0245 +1080 2 49.794 0.627079 33.5149 3.58551 37.6409 23.5907 +1081 2 49.1504 41.7362 34.5845 -39.3958 -31.0429 53.6988 +1082 3 49.3072 40.5133 34.7023 12.9245 12.8492 -11.6005 +1083 4 51.5663 41.4343 33.8516 -6.054 3.49016 -14.1934 +1084 4 49.5236 1.72635 33.6347 -1.89472 -11.9516 -1.26615 +1085 2 49.2899 0.093076 32.2111 -20.0469 10.239 -57.1496 +1086 2 49.5504 1.0758 31.0546 44.1484 5.96661 -35.419 +1087 1 48.7105 2.02971 30.4517 -2.34523 -25.3315 39.2373 +1088 2 50.7977 1.22066 30.3277 -75.7848 7.88288 4.96893 +1089 2 49.299 2.59293 29.3763 -23.865 8.39496 11.0232 +1090 1 50.5677 2.14293 29.3127 -12.36 -15.4034 27.3398 +1091 4 48.1533 41.8436 32.187 18.4481 1.21563 9.00361 +1092 4 49.725 40.9798 32.0543 -2.35302 7.24771 -7.56512 +1093 4 47.7373 2.26457 30.8018 19.6426 -7.09987 -8.69392 +1094 4 51.6402 0.582035 30.3922 15.3203 -1.97636 0.19948 +1095 4 48.6832 3.25559 28.7541 24.649 -5.28154 -1.94766 +1096 4 51.2124 2.39582 28.5799 18.4236 6.97779 -14.3308 +1097 1 48.3633 0.438016 35.503 -1.69139 30.1001 11.6909 +1098 2 47.6687 41.7006 36.6492 0.613805 18.6924 -40.9612 +1099 2 46.264 41.3694 36.1307 -7.02361 -30.4834 5.87484 +1100 3 45.3463 0.246853 35.8895 18.8914 5.06283 8.3795 +1101 4 48.1281 1.45816 35.4039 5.5506 -16.4063 -0.101422 +1102 4 48.2062 40.7837 36.9784 6.36967 -2.21031 -8.42979 +1103 2 47.5958 0.687745 37.8565 -25.4558 59.2473 29.5222 +1104 2 46.6931 0.064749 39.0402 -2.78345 4.00632 18.8053 +1105 2 47.0383 40.4557 39.4221 -33.2538 18.6268 -20.4936 +1106 2 46.93 0.927044 40.3419 31.4794 -11.2994 1.29194 +1107 4 47.1354 1.76149 37.5629 9.48386 -42.5729 7.15928 +1108 4 48.6298 0.997945 38.2155 -14.6806 -19.3715 -2.98409 +1109 4 45.5391 0.148422 38.8474 30.3772 -4.98305 -7.99897 +1110 4 47.9695 40.2725 39.9165 32.6255 3.33763 11.188 +1111 4 46.9967 39.7545 38.5575 0.158611 5.44488 0.559019 +1112 4 46.2719 40.0836 40.1333 -2.82757 0.291607 -0.331179 +1113 4 48.0832 1.04093 40.5802 -35.3824 -1.71169 -8.39188 +1114 4 46.4823 0.388091 41.2333 0.118939 13.4124 -7.57083 +1115 4 46.4764 1.95182 40.2253 3.79994 -8.06745 5.67231 +1116 1 46.1155 40.0363 35.9994 32.2071 3.49142 -20.6914 +1117 2 44.9353 39.2817 35.7114 0.014229 -40.6503 61.2515 +1118 2 44.4179 38.8949 37.157 4.06758 -27.6469 18.473 +1119 3 45.1574 38.4668 38.0935 -15.0116 19.769 -34.2637 +1120 4 46.9934 39.487 36.0733 -14.8983 -9.5139 0.794979 +1121 4 44.1193 39.9156 35.4266 -15.9448 22.0113 -37.9939 +1122 2 45.2307 37.9502 34.8403 3.73878 29.7444 42.1248 +1123 2 44.043 37.0324 34.841 -52.9272 -13.7306 14.9234 +1124 2 45.6185 38.368 33.4399 7.42128 1.51593 -38.9882 +1125 4 46.0406 37.394 35.3664 8.69137 1.61483 -3.86581 +1126 4 43.4486 36.945 35.811 20.0159 3.18287 -12.2628 +1127 4 44.3645 35.9957 34.6605 0.118723 -8.68919 -11.9568 +1128 4 43.2413 37.3473 34.1301 7.80666 -3.9283 -7.25571 +1129 4 46.619 38.86 33.4411 -0.357581 -2.40345 0.816384 +1130 4 44.931 39.1517 33.0584 -3.3954 -0.0150932 -1.42103 +1131 4 45.65 37.5606 32.6192 -0.759822 9.78394 24.304 +1132 1 43.0637 38.9039 37.3301 16.2039 -1.11298 52.5829 +1133 2 42.3901 38.4825 38.6382 8.13363 32.9232 -36.228 +1134 2 41.8706 37.0909 38.467 10.8397 -12.8704 71.8875 +1135 3 41.4837 36.7016 37.4073 -23.2793 -18.8499 -56.9312 +1136 4 42.5052 38.9697 36.5072 -31.8536 4.61581 -21.2592 +1137 4 43.1805 38.4127 39.3754 18.2924 -0.774441 22.1039 +1138 2 41.3003 39.5089 39.1545 11.9555 -3.56475 0.849013 +1139 2 41.9844 40.8891 39.6202 11.8289 -38.672 35.4909 +1140 2 41.1032 0.170603 39.4187 0.299182 35.0028 -21.1028 +1141 2 42.4599 40.8175 41.1074 30.4283 -6.43954 -3.58257 +1142 4 40.7378 39.0113 40.0259 3.55617 13.764 -16.8053 +1143 4 40.5882 39.6834 38.2893 4.7664 -2.44084 15.6093 +1144 4 42.9174 41.0251 39.0897 16.4872 7.11459 -27.4623 +1145 4 41.5448 1.21778 39.6878 -5.64292 -30.3916 -9.38981 +1146 4 40.1969 0.063548 40.0003 -21.2204 -0.202137 11.1399 +1147 4 40.8028 0.152067 38.3319 -0.566182 12.1591 9.51378 +1148 4 41.6814 40.5448 41.8308 -8.42244 -8.91154 4.32363 +1149 4 42.887 41.7652 41.4977 -6.37808 7.37928 -6.87517 +1150 4 43.378 40.1338 41.1957 -24.337 0.845851 0.000130478 +1151 1 41.833 36.287 39.5864 -11.7269 -9.12911 -32.1296 +1152 2 41.2021 34.942 39.6247 -13.3362 -7.3841 -33.9439 +1153 2 39.8438 35.1095 40.3167 -2.23182 -18.8086 0.488263 +1154 3 39.8319 35.4679 41.5133 -14.6884 5.15074 -23.9167 +1155 4 42.1857 36.6275 40.4819 6.41783 1.01312 8.70708 +1156 4 41.0734 34.4248 38.4971 0.391294 34.8961 43.783 +1157 2 42.0436 33.9307 40.4129 10.4134 -33.9193 29.8386 +1158 2 41.3224 32.6645 41.0046 18.9395 -8.84266 -15.0635 +1159 2 42.1741 31.41 41.1086 26.4224 -37.0889 -5.20117 +1160 1 43.3231 31.527 0.12404 8.16009 54.2467 4.49909 +1161 2 44.392 30.7336 0.312631 -11.8213 -13.5239 -25.8004 +1162 1 44.683 29.6211 41.5456 -0.875823 -13.5136 -9.93246 +1163 1 45.3567 31.1357 1.10637 -40.5913 52.4111 16.4216 +1164 4 42.6035 34.3028 41.3288 -3.49471 12.9719 -23.3931 +1165 4 42.7742 33.539 39.6653 10.0701 4.50298 5.32726 +1166 4 40.5106 32.3417 40.3808 -25.7726 1.2565 -24.6898 +1167 4 40.8602 32.7415 0.05618 -15.4481 23.3498 31.3369 +1168 4 42.5775 31.2408 40.0556 -4.97325 -9.97334 14.9806 +1169 4 41.5239 30.4863 41.4302 18.1675 25.5375 -11.7586 +1170 4 43.4773 32.5278 0.495625 -12.2609 -36.3484 -6.98406 +1171 4 44.1847 29.2591 40.6938 -0.904676 10.2844 18.7349 +1172 4 45.5197 29.0942 41.8602 -5.70345 -5.08504 -8.10101 +1173 4 45.1981 31.9946 1.67722 9.89922 -9.52065 -4.53153 +1174 4 46.1063 30.5613 1.39407 36.7186 -26.409 10.0907 +1175 1 38.7328 34.6894 39.6013 4.46457 11.7984 -0.102478 +1176 2 37.3765 34.7683 40.1611 -21.3466 -3.56213 -4.53749 +1177 2 37.2086 33.6902 41.246 35.3807 -34.3386 -58.3615 +1178 3 37.7056 32.5617 40.9531 -12.3371 14.3328 36.9617 +1179 4 38.7903 34.2139 38.6548 1.70782 19.6852 25.699 +1180 4 37.2103 35.7436 40.6571 5.74575 10.1154 -0.0963519 +1181 2 36.2415 34.546 39.0669 -3.18027 -0.0437456 15.212 +1182 2 36.1408 35.6492 37.9204 39.4301 -27.8538 10.4422 +1183 2 35.3755 35.0392 36.7616 2.61616 7.91146 -44.6699 +1184 2 35.4893 36.9279 38.4153 -43.6456 26.6605 -35.0263 +1185 4 35.2587 34.5127 39.627 5.22859 0.340849 -7.95454 +1186 4 36.3572 33.4874 38.6664 0.260323 14.7009 0.217726 +1187 4 37.2087 35.8382 37.5664 -16.1128 3.65721 5.42823 +1188 4 35.4477 35.6456 35.7653 9.36321 -17.9472 26.5571 +1189 4 34.3056 35.0154 36.9225 -21.8403 -4.8414 12.2215 +1190 4 35.6878 33.9672 36.6241 -0.675121 9.51327 -11.2908 +1191 4 35.3533 37.7352 37.5449 14.646 -26.9923 30.0517 +1192 4 36.0883 37.365 39.2255 0.238586 8.99863 9.94523 +1193 4 34.398 36.7236 38.7331 27.4296 3.60145 2.66053 +1194 1 36.5178 33.9861 0.43319 -0.886806 18.5628 10.9627 +1195 2 36.4316 33.2481 1.68402 -23.714 -26.6299 -2.13495 +1196 2 35.1244 33.7124 2.42366 15.5385 -30.3313 2.36588 +1197 3 34.7644 34.9026 2.51705 2.20922 -14.5348 -10.7235 +1198 4 35.9714 34.8641 0.38304 3.21168 -9.87759 6.15105 +1199 4 36.3983 32.0948 1.44989 -1.82422 33.6343 5.26777 +1200 2 37.6595 33.5578 2.59019 11.8109 -15.526 -8.95992 +1201 2 37.7925 32.6548 3.8947 -1.46637 37.0951 -40.7395 +1202 2 39.0729 32.9162 4.76145 9.33062 17.9701 -6.69315 +1203 1 39.1272 34.3057 5.34055 -12.0513 -47.2871 -14.6565 +1204 2 40.0361 34.6964 6.22226 19.4309 2.99614 33.8109 +1205 1 41.0505 33.9844 6.76852 5.72064 -28.58 -41.8643 +1206 1 39.7581 35.8909 6.75898 -16.291 -41.0737 -43.8581 +1207 4 37.6558 34.6526 2.69615 5.74115 8.80853 20.4616 +1208 4 38.5677 33.342 1.97837 2.62182 1.38243 0.976295 +1209 4 37.7082 31.6119 3.52088 7.51898 -7.43262 10.1799 +1210 4 36.8684 32.8569 4.46033 -3.22235 -4.22142 15.6354 +1211 4 40.0987 32.7161 4.26669 -27.6432 -2.90908 0.926336 +1212 4 38.962 32.1623 5.56307 10.4764 0.325422 12.3641 +1213 4 38.2956 34.9173 5.26655 4.54825 -8.39051 -8.34855 +1214 4 41.5169 33.1039 6.38476 -28.6266 25.8655 1.14646 +1215 4 41.608 34.3491 7.51377 7.8916 19.9746 23.1278 +1216 4 38.9281 36.336 6.40181 -18.5651 19.0558 1.42199 +1217 4 40.2702 36.4189 7.40653 35.8571 19.9594 40.0309 +1218 1 34.4344 32.6714 2.9841 11.9274 27.4669 5.1488 +1219 2 33.2874 32.9292 3.81699 -8.08564 -7.68863 -5.88537 +1220 2 32.3224 31.7651 3.90854 -17.2979 -17.3182 38.1098 +1221 3 31.6331 31.611 4.98833 24.1293 6.49939 -41.9496 +1222 4 34.8176 31.7057 3.00707 -6.83555 3.8884 -0.368261 +1223 4 33.5991 33.291 4.83995 -4.39941 -8.915 -13.4113 +1224 4 32.6658 33.7351 3.38441 -0.220857 8.92322 -1.65762 +1225 1 32.2676 30.8833 2.86064 7.18924 -6.28537 -11.1453 +1226 2 31.5304 29.6622 2.84554 -44.3988 -8.55194 41.4736 +1227 2 32.0114 28.4719 1.98523 24.1065 42.5964 20.3644 +1228 3 31.2338 27.9142 1.1781 -2.45095 -15.5808 -11.9787 +1229 4 32.835 30.9065 1.99868 7.60542 11.1676 6.22148 +1230 4 31.4977 29.325 3.94534 -1.848 -5.68036 -21.1002 +1231 4 30.428 29.9278 2.63242 23.021 -11.1829 0.219584 +1232 3 33.2484 28.1785 2.03016 -12.1294 -5.65166 -6.61988 +1233 6 29.6841 33.0367 2.60309 -21.6771 -19.3453 -3.47113 +1234 4 28.7948 33.122 2.96731 -0.0142705 6.34055 1.55972 +1235 4 29.6278 32.12 2.27587 17.6678 13.2788 -5.74715 +1236 6 1.91248 24.7582 28.0699 4.20875 0.224039 17.8866 +1237 4 1.01839 24.445 28.2798 3.51323 0.855994 -2.65004 +1238 4 2.43926 24.5752 28.8738 -5.90795 -3.90565 -13.7536 +1239 6 8.97597 35.4266 7.06834 5.04 -9.06312 -1.25332 +1240 4 8.25108 36.0541 6.94232 -0.597114 -1.88223 0.564045 +1241 4 9.78632 35.9205 6.90416 2.6498 8.25727 -2.9232 +1242 6 37.9306 35.2271 23.5275 -29.4197 8.6633 8.88923 +1243 4 37.6331 35.3765 22.6307 -13.538 -1.59668 -6.74716 +1244 4 38.842 35.1051 23.4294 41.2281 -9.97035 -1.96517 +1245 6 11.37 34.6061 20.3231 29.8185 18.8627 -18.7977 +1246 4 10.4583 34.7066 20.5358 -23.2141 -5.0309 12.4901 +1247 4 11.7775 33.9686 20.9051 -0.738527 -14.291 8.66526 +1248 6 3.04799 13.1152 13.5136 35.0099 19.4917 13.0876 +1249 4 2.1896 12.8159 13.7818 -12.1985 -3.35561 6.33527 +1250 4 3.35102 13.7724 14.1976 -9.84998 -14.2313 -17.3692 +1251 6 9.17749 22.3786 24.885 -4.81993 3.49977 17.5169 +1252 4 8.99718 21.9861 24.0258 2.67933 0.293026 -6.97176 +1253 4 8.3097 22.5185 25.3032 2.93356 -2.2731 -6.67367 +1254 6 31.1417 36.1188 7.44168 3.96214 -4.62609 4.57576 +1255 4 30.9859 35.1633 7.26174 3.91063 19.8072 -8.10584 +1256 4 31.8759 36.4086 6.86762 -9.43736 -11.0335 0.220205 +1257 6 20.3122 0.171955 30.1364 24.228 8.43021 7.74329 +1258 4 20.1467 1.09565 29.8896 -9.06662 -5.17995 0.122132 +1259 4 21.2388 0.205679 30.4532 -11.6638 -2.99571 -4.85501 +1260 6 32.6752 3.01477 5.14905 7.73556 0.409651 25.0992 +1261 4 32.0607 2.27652 4.98052 6.16059 10.1356 9.58904 +1262 4 32.7887 3.0902 6.13894 -10.3787 -11.0045 -24.4474 +1263 6 26.2394 8.28697 11.5977 20.1187 4.68976 23.8355 +1264 4 26.2546 7.39802 11.997 -1.81228 7.23555 -2.12718 +1265 4 26.8422 8.82061 12.1901 -18.4274 -19.7459 -23.7973 +1266 6 1.08156 20.2558 0.892389 0.445896 -40.4816 -11.3523 +1267 4 0.921065 19.2784 0.845371 -9.22979 28.4068 22.5673 +1268 4 1.8129 20.2775 0.290341 19.5395 18.0975 -11.5753 +1269 6 29.152 22.9159 1.42964 -10.353 11.3862 1.77115 +1270 4 28.6638 23.7219 1.70393 12.045 -15.0113 -5.27942 +1271 4 29.6471 22.6066 2.20087 0.367353 7.17244 2.17898 +1272 6 34.1439 34.8173 6.47837 -14.6134 34.7664 -13.6599 +1273 4 34.8234 34.3556 6.01831 17.3611 -13.8412 -2.82442 +1274 4 33.8746 34.3136 7.2252 -0.385324 -14.0922 18.4225 +1275 6 25.1602 37.1811 26.5285 37.3138 -10.4299 -24.6025 +1276 4 24.6611 37.8475 26.9305 -29.1138 25.753 30.5337 +1277 4 25.9902 37.6718 26.3423 -2.02618 -10.7722 -5.27175 +1278 6 14.5359 22.233 15.6757 -38.1082 -52.4317 -17.2355 +1279 4 14.0373 21.3219 15.6008 31.4468 51.1923 15.0921 +1280 4 14.2115 22.7284 14.9124 6.42666 2.88962 4.6194 +1281 6 2.85765 5.85542 4.07926 -11.0889 31.9932 11.5474 +1282 4 3.43051 5.71014 4.8302 4.50985 -17.8875 11.7313 +1283 4 2.47546 6.74142 4.27679 -1.8522 -19.462 -7.62003 +1284 6 27.6173 26.7153 22.7048 3.02536 -24.7668 37.2 +1285 4 26.7794 26.2561 22.7471 -5.49099 -10.4557 3.23975 +1286 4 27.5338 27.2427 21.9498 -2.81898 29.5538 -40.3285 +1287 6 17.7815 0.60275 22.3967 -9.44347 22.192 16.8557 +1288 4 17.1106 0.664367 23.1174 8.05472 -4.70436 -13.4643 +1289 4 18.0991 1.53066 22.3547 -2.50437 -12.3009 -7.04453 +1290 6 8.08803 9.43976 10.5674 4.80966 -47.9744 28.0614 +1291 4 8.01535 10.2871 10.1695 -8.25869 32.7817 1.56345 +1292 4 8.12483 9.46261 11.5696 0.628604 12.1613 -30.4224 +1293 6 15.3459 8.71493 30.7579 -11.6347 7.91644 6.32427 +1294 4 15.6589 9.0755 29.9373 15.0271 -3.29406 -15.5675 +1295 4 14.5238 9.21191 30.8811 4.80809 -7.40019 11.405 +1296 6 11.0133 17.2839 37.5617 38.0352 -12.2544 -11.7999 +1297 4 10.7898 18.2056 37.405 -17.5453 -0.0751596 7.29682 +1298 4 10.2607 16.7791 37.8546 -17.0302 3.42722 4.74802 +1299 6 42.1004 25.1498 20.3879 -5.861 18.5914 -24.6259 +1300 4 41.6093 25.7579 19.7998 14.6917 -4.46771 2.10695 +1301 4 41.6207 25.2703 21.1911 -4.19275 -5.86855 25.2901 +1302 6 25.8665 4.70671 33.8486 1.7241 -2.25531 12.4518 +1303 4 25.7694 4.46132 32.9448 -0.891619 -14.6084 -22.569 +1304 4 25.7648 5.65611 33.7952 0.475958 14.7418 11.4125 +1305 6 28.7412 10.81 24.3536 52.8166 -39.1996 0.778281 +1306 4 29.1275 10.6396 25.241 -21.7381 14.0631 -10.6288 +1307 4 29.4032 10.2753 23.8346 -27.1554 16.6107 -4.2243 +1308 6 5.01189 41.8147 11.1021 -10.1881 -24.042 21.7575 +1309 4 5.95007 41.5814 10.9281 -9.39093 5.64723 11.7156 +1310 4 4.65803 41.218 11.8386 16.8172 15.7397 -32.6044 +1311 6 51.752 12.7769 30.1551 43.115 4.76279 10.9474 +1312 4 51.4305 13.1775 29.3474 0.253404 7.28674 -13.194 +1313 4 52.748 12.9494 30.1798 -32.3905 -5.4963 0.108494 +1314 6 7.60816 6.20909 6.53323 -10.2625 -22.9413 3.332 +1315 4 6.75131 6.36879 6.93991 1.04412 16.1391 1.16177 +1316 4 7.47061 5.28848 6.27373 8.51121 0.713964 -9.51027 +1317 6 14.6661 26.987 30.1548 0.873164 4.36141 0.355215 +1318 4 14.582 27.1099 31.1251 1.36022 -4.92112 -14.8153 +1319 4 15.2266 27.7026 29.8055 -8.21389 -0.931444 11.6021 +1320 6 15.3264 3.73283 21.1643 -10.33 -3.58504 -6.01241 +1321 4 14.8638 4.27764 21.8464 -0.83547 -19.2341 -16.6374 +1322 4 14.7237 3.15769 20.6119 12.9204 22.2517 21.9232 +1323 6 18.6273 30.44 6.46759 12.0392 -23.7352 17.6185 +1324 4 19.0475 29.6706 6.98693 -16.3462 35.3997 -15.3304 +1325 4 19.3457 31.0864 6.33287 -5.93154 -6.64461 4.30044 +1326 6 40.7697 1.30953 12.81 -7.42069 2.69181 -0.220133 +1327 4 39.8771 1.67487 12.9664 8.30469 -1.85755 -8.75546 +1328 4 41.0842 1.69163 11.9727 1.23155 -3.30642 0.910493 +1329 6 17.7383 20.7435 41.5913 -9.25323 7.68498 -13.188 +1330 4 16.7989 21.0745 41.5362 27.0903 -5.35562 -1.00027 +1331 4 18.2994 21.1605 40.9095 -9.45455 4.50919 10.4973 +1332 6 20.4558 2.13279 12.3403 -30.0447 18.1891 -47.0851 +1333 4 19.8108 1.39557 12.2573 15.3988 9.29294 19.6505 +1334 4 20.198 2.64755 11.5038 12.9177 -17.2886 33.121 +1335 6 9.85302 37.1833 18.074 6.71136 -14.9304 -23.7857 +1336 4 9.92221 37.5908 18.9423 10.0316 4.42551 4.50256 +1337 4 10.7455 37.1149 17.635 -18.8442 6.56171 18.5414 +1338 6 22.8282 7.40677 18.9114 -6.23678 0.804763 -35.7596 +1339 4 23.277 7.74075 18.0859 -11.7777 -2.90663 21.4919 +1340 4 21.8757 7.287 18.6972 16.9035 1.85128 0.334711 +1341 6 12.8573 6.85868 39.0594 6.78943 -21.4649 -19.4044 +1342 4 12.3495 7.63841 39.2092 -16.9303 20.8315 3.03628 +1343 4 13.4346 6.77393 39.8096 4.28484 1.06254 16.6435 +1344 6 10.1565 2.40612 23.2517 -6.6479 23.561 31.1588 +1345 4 10.4099 1.98923 22.4441 -4.01424 -6.38426 -29.0568 +1346 4 9.49005 3.10319 23.0571 9.63138 -11.2124 -3.87372 +1347 6 12.5542 20.2161 19.5705 -7.34833 3.07917 -34.9419 +1348 4 11.7057 19.8107 19.7825 -3.93433 -3.45282 3.31954 +1349 4 12.4683 20.3478 18.5882 13.2674 0.522362 30.6915 +1350 6 53.8557 6.35775 18.9347 50.5758 7.3162 -16.743 +1351 4 53.0168 6.07594 19.2456 -23.2698 -10.9568 16.0684 +1352 4 54.5479 6.04339 19.5529 -19.4302 5.44353 -5.27334 +1353 6 1.75058 4.00903 13.2441 23.5728 -28.6973 -20.2265 +1354 4 1.21884 4.54583 13.7916 -24.4496 15.7193 15.6535 +1355 4 1.39876 3.10072 13.3493 7.47096 11.1043 -1.96467 +1356 6 2.68902 16.4655 4.58797 17.5454 -16.7281 26.1549 +1357 4 3.46748 16.2798 5.17846 -23.6637 11.3752 -17.7986 +1358 4 3.0109 17.1109 3.97132 2.36318 9.59715 -15.9168 +1359 6 22.6274 7.40182 35.0529 -33.099 -8.93325 -69.8706 +1360 4 21.8922 7.07895 34.3703 46.348 20.1786 48.898 +1361 4 22.5995 6.76718 35.7474 -8.35572 -20.8537 22.0506 +1362 6 30.6396 27.885 19.9 19.0923 35.3411 -25.0547 +1363 4 31.1106 28.5954 19.3754 -18.5592 -24.8751 19.2783 +1364 4 29.9814 27.5098 19.295 5.17179 -8.35919 5.46264 +1365 6 18.3573 9.54392 6.2041 9.96047 7.12844 39.1223 +1366 4 18.327 9.09374 5.37857 3.10343 -12.6247 -24.8999 +1367 4 19.1177 9.18386 6.70986 -9.9052 0.872737 -11.1311 +1368 6 21.018 30.3894 30.8381 -12.2875 -2.46479 40.1773 +1369 4 21.7266 31.0151 30.932 9.98027 8.24448 -8.07198 +1370 4 20.7269 30.28 31.7939 -0.642204 -5.24287 -40.3987 +1371 6 28.323 4.36597 15.0837 1.12527 39.8195 10.6489 +1372 4 27.8986 3.55092 15.2676 -12.4099 -32.2848 2.02696 +1373 4 29.0009 4.19376 14.4446 14.1396 -7.65384 -8.86362 +1374 6 12.7814 0.64254 16.5262 -20.2521 41.8336 -1.49998 +1375 4 13.0387 1.47629 17.0069 -1.64601 -27.4009 -13.133 +1376 4 12.0897 0.933072 15.8712 20.715 -4.46996 16.4219 +1377 6 27.5603 35.1844 8.24072 -26.8161 -1.20469 12.7263 +1378 4 28.0791 35.3455 7.47089 6.94403 2.76433 -19.537 +1379 4 26.8275 34.582 7.96906 18.9853 12.4469 9.56437 +1380 6 24.0704 5.17451 40.9985 43.9791 -14.9803 45.716 +1381 4 24.6298 5.96615 41.2045 -19.6374 -8.83437 -20.0494 +1382 4 23.3625 5.28724 40.4007 -22.1054 20.8081 -27.5224 +1383 6 16.8467 24.9145 28.3061 -32.8066 71.0274 -23.4158 +1384 4 15.8676 25.1613 28.454 39.6061 -31.4713 1.92714 +1385 4 17.0718 25.6559 27.6632 3.37355 -28.1253 20.4487 +1386 6 20.8411 12.7971 17.0095 43.3655 -24.1139 -5.17775 +1387 4 20.9692 13.6698 17.4217 0.0861137 -1.96629 -7.53612 +1388 4 21.7712 12.4167 16.7645 -47.1299 18.5523 16.3808 +1389 6 35.7683 23.0344 30.9263 1.08866 -13.108 5.55839 +1390 4 34.803 23.1301 30.928 3.64223 -3.31893 2.04139 +1391 4 35.9803 22.5404 31.7512 0.26244 15.2618 -11.5602 +1392 6 36.3065 21.404 25.8788 21.1988 16.3215 -11.4752 +1393 4 35.3711 21.2912 25.8279 -29.04 -8.19979 -7.71966 +1394 4 36.6742 20.6179 26.2596 7.44281 -15.7003 9.85929 +1395 6 13.4865 6.74911 5.29345 -32.6693 78.3701 45.7352 +1396 4 13.9616 6.05619 4.98306 41.5093 -80.328 -47.9816 +1397 4 12.7805 7.00791 4.71674 -14.9335 -5.37764 -13.3979 +1398 6 20.8104 20.4092 13.7653 1.99296 11.0688 -14.7475 +1399 4 21.268 20.4545 14.5989 11.9976 -3.76106 7.6647 +1400 4 19.8959 20.3184 13.9984 -15.4264 -4.27358 -1.02469 +1401 6 20.3637 29.125 1.38742 -7.39452 3.20569 15.6829 +1402 4 20.6257 29.8678 1.97015 -13.6171 -7.9879 -3.97808 +1403 4 19.4728 28.7955 1.69287 22.5847 10.4694 -9.78123 +1404 6 50.8792 13.1212 37.2655 -4.22961 23.9091 37.9372 +1405 4 51.3893 12.5589 37.8771 -2.47029 4.54984 -9.0483 +1406 4 50.5869 13.8674 37.8656 5.03029 -21.5284 -25.2034 +1407 6 33.9282 34.1694 20.494 -12.758 16.9363 4.62304 +1408 4 33.9505 34.3661 19.5368 -1.52487 0.481952 13.5649 +1409 4 33.2327 34.7631 20.901 14.0918 -19.53 -17.3949 +1410 6 26.2111 28.0581 27.5584 -15.6012 -12.4051 -9.62147 +1411 4 26.6887 28.3319 28.3498 -5.67664 4.83839 -0.885474 +1412 4 25.2376 28.0657 27.7416 20.5709 -1.16679 -1.23567 +1413 6 7.682 21.3042 4.28531 -31.6563 9.11884 52.3302 +1414 4 8.36407 20.9023 3.81015 41.1991 -18.6864 -33.8238 +1415 4 7.19271 21.9105 3.74865 -6.01459 10.7978 -19.2095 +1416 6 22.0049 15.1615 5.91526 -5.59087 32.8095 7.59658 +1417 4 22.5291 15.4011 5.14076 -1.79158 -8.25489 -6.60562 +1418 4 21.8369 14.2416 6.04435 2.97447 -25.4321 -3.26552 +1419 6 21.7136 24.0096 3.8157 22.5859 -13.9702 -11.1371 +1420 4 22.6792 24.1846 3.95073 -20.2229 4.30251 2.28349 +1421 4 21.6957 23.2604 3.18041 -1.04284 4.75891 13.5064 +1422 6 11.5672 23.7812 12.5534 10.6653 17.5289 -0.525849 +1423 4 11.8567 24.7317 12.4283 -11.704 -31.033 2.93832 +1424 4 11.2483 23.6794 13.4494 -5.02459 5.94744 7.15157 +1425 6 32.3679 18.058 29.8144 -2.59991 12.5874 27.6023 +1426 4 33.2958 17.8537 29.9681 1.40206 -2.08885 -2.88861 +1427 4 32.1708 17.8352 28.9168 3.64727 -16.5589 -23.8097 +1428 6 9.27501 12.3901 30.3257 8.89695 -9.73537 -4.18026 +1429 4 8.97738 13.0169 30.9954 -4.04452 2.00113 -0.0309771 +1430 4 10.1278 12.0418 30.6776 -19.7256 9.24572 -11.0885 +1431 6 40.1671 25.9203 9.1352 -31.1658 -6.55029 4.71016 +1432 4 40.7952 25.2818 9.45931 8.36253 -10.0667 -0.250848 +1433 4 40.6474 26.7215 9.01492 17.3912 21.2934 -6.4579 +1434 6 43.1616 32.3487 37.3267 7.45809 -19.2286 11.3512 +1435 4 42.8399 32.8446 36.5586 -11.2032 -5.45956 10.184 +1436 4 42.4733 31.7245 37.6799 8.3011 17.0164 -20.2151 +1437 6 44.0911 6.28198 31.259 8.64406 -6.47735 -33.2401 +1438 4 43.4563 6.84482 31.6606 -21.1773 24.4303 10.8162 +1439 4 44.5952 5.92873 31.9644 15.9286 -14.2375 24.3689 +1440 6 10.2063 18.8787 19.6978 14.6089 -0.63771 -2.74842 +1441 4 10.128 18.3979 20.5267 6.04825 -4.13467 -1.20166 +1442 4 9.36891 19.3219 19.635 -15.0357 8.38504 -1.1225 +1443 6 7.0561 15.5922 15.0299 -16.4573 19.9198 -23.3889 +1444 4 7.18612 15.4783 14.0721 1.05096 2.95086 4.94392 +1445 4 7.41457 14.833 15.4354 13.8635 -34.6267 13.25 +1446 6 24.544 3.4899 27.8655 -14.5565 -8.97091 -7.81951 +1447 4 23.6823 3.28725 28.2588 1.61952 11.0081 14.175 +1448 4 24.3729 3.16547 26.9791 10.0044 -2.74415 -7.35546 +1449 6 54.4109 31.8087 9.71194 -6.99911 23.6955 33.3298 +1450 4 53.8413 31.5567 9.00593 -8.22136 -4.9258 -26.1741 +1451 4 54.0752 32.6964 9.97695 10.2913 -15.383 -7.59421 +1452 6 6.81072 17.0817 36.2069 -39.6649 -0.569341 -18.8672 +1453 4 5.9036 16.7161 36.0961 17.2423 3.35707 18.397 +1454 4 7.03883 17.1994 35.2786 19.8939 2.17194 6.76773 +1455 6 28.6373 7.46216 20.4204 -3.00228 3.72915 -26.9716 +1456 4 27.791 7.71165 20.8314 -1.23568 -3.59083 -7.19581 +1457 4 28.5788 7.67124 19.4449 -3.89686 1.20908 30.1283 +1458 6 17.0427 1.7136 8.36469 -7.39711 4.96373 -17.441 +1459 4 16.9511 0.79552 8.17539 8.34993 -30.6792 14.2707 +1460 4 16.7364 2.03503 7.50962 2.58977 23.9868 7.32556 +1461 6 19.1319 19.334 35.5748 25.2315 11.3156 3.71898 +1462 4 18.4163 18.7293 35.4559 -12.7574 -15.0058 -3.77114 +1463 4 19.9108 18.8059 35.8312 -7.49406 2.79856 2.97864 +1464 6 7.31044 31.3665 13.5876 -12.5896 -10.3186 -18.1643 +1465 4 6.86348 30.5057 13.838 5.41483 30.5465 -8.86898 +1466 4 6.71656 31.9291 13.023 7.05746 -22.9991 7.02109 +1467 6 16.6555 5.24573 12.8486 0.44122 -36.1931 20.2204 +1468 4 17.4189 5.79101 12.9112 23.6003 17.0932 2.01526 +1469 4 16.8511 4.45507 13.4194 -12.0332 11.5633 -21.5138 +1470 6 43.8917 12.7482 34.58 -33.2024 -13.6106 -1.45858 +1471 4 43.9807 13.5999 34.156 2.60816 15.5254 -0.13451 +1472 4 42.9242 12.5381 34.5161 22.3754 -3.96122 -2.5942 +1473 6 42.656 36.4522 28.5282 -7.17959 22.9727 1.13167 +1474 4 42.279 37.3416 28.6522 -7.55712 -15.8866 -0.526154 +1475 4 43.5285 36.675 28.2003 16.3904 -10.8581 0.329061 +1476 6 35.3704 15.0467 6.02622 35.7531 43.3754 17.6476 +1477 4 35.9258 15.8884 5.86958 -26.5611 -35.5954 0.991204 +1478 4 34.7923 14.9488 5.27074 -5.69332 -0.0870189 -10.0798 +1479 6 19.4034 5.85396 6.19026 -42.6676 -37.2433 -25.4755 +1480 4 18.4973 6.11578 6.46985 14.7962 -6.51198 7.73248 +1481 4 20.0178 6.47164 6.48735 29.6225 43.4574 23.1864 +1482 6 29.2636 38.16 6.98139 -51.0091 34.2659 0.167673 +1483 4 28.4794 38.0546 7.56687 16.6219 5.90534 -14.0005 +1484 4 29.8812 37.5458 7.29338 34.0617 -33.3732 10.6718 +1485 6 19.3639 26.1879 8.4772 -1.75021 -19.5484 18.4946 +1486 4 19.3765 25.7536 9.37133 0.505418 11.6152 -20.7618 +1487 4 20.132 25.8039 8.02679 -2.64689 1.58972 6.88257 +1488 6 4.91801 16.6546 6.12902 16.8332 -1.31437 8.04366 +1489 4 5.58152 17.3 5.84506 -6.45866 4.1219 -0.991793 +1490 4 5.39084 15.8022 6.09449 -7.75564 17.9483 -2.53018 +1491 6 6.07873 16.6931 28.0679 20.4204 4.35008 -35.2212 +1492 4 5.19925 16.4426 27.8453 -29.7482 -9.15572 9.47762 +1493 4 6.44387 16.7631 27.1426 -3.77999 2.92972 38.3228 +1494 6 21.7313 29.3584 22.0941 -19.989 26.599 40.0594 +1495 4 21.5191 30.3374 22.0902 3.30888 -28.6715 -0.0155919 +1496 4 21.2646 29.0087 22.9228 20.4195 8.84702 -28.341 +1497 6 24.487 0.545827 12.8459 24.5625 -19.0276 8.44191 +1498 4 24.0381 0.883409 12.0817 -9.22903 10.6064 -10.7293 +1499 4 24.0836 0.980384 13.5911 -6.14963 8.46579 8.44801 +1500 6 18.4109 28.2545 40.3162 -15.9129 36.5713 -32.2972 +1501 4 18.3366 27.7076 41.0573 0.952339 -31.6797 34.0712 +1502 4 19.1875 27.9677 39.8503 10.0284 -2.61836 -5.50219 +1503 6 10.3807 17.4604 21.8947 -1.20821 -16.3296 3.13877 +1504 4 9.80057 16.6779 21.8113 10.8468 3.86983 1.60142 +1505 4 10.0443 17.9356 22.6521 -9.33664 9.03137 6.2204 +1506 6 13.5404 13.3591 39.6327 12.5768 11.767 30.0264 +1507 4 13.9188 14.1992 39.2886 -9.97897 -11.5724 13.3172 +1508 4 13.5464 13.3749 40.6413 1.33606 5.90172 -38.0522 +1509 6 19.5508 26.0247 24.7387 -47.8665 -1.21537 -13.2845 +1510 4 19.6189 25.3328 24.097 -5.62542 -9.91951 -19.3965 +1511 4 20.3649 25.9852 25.1641 45.3739 3.88293 31.7071 +1512 6 8.93445 25.8823 20.0822 -10.4543 -29.9419 8.18251 +1513 4 8.35083 26.4773 20.5043 -33.2288 11.519 27.1484 +1514 4 9.504 26.5029 19.6962 43.6798 16.1155 -28.0388 +1515 6 13.4493 41.2138 30.5102 -4.84662 -36.1256 25.75 +1516 4 14.2597 41.094 31.0483 -5.58856 8.18726 -8.9115 +1517 4 12.8416 40.5025 30.8796 12.8197 27.661 -18.9522 +1518 6 21.1596 21.6794 11.1163 10.7366 20.8259 2.41134 +1519 4 20.9554 20.8709 10.6777 -10.2383 -24.5438 -10.817 +1520 4 21.2276 21.4421 12.046 -2.84377 -3.57945 5.82209 +1521 6 43.5643 10.3136 15.5616 17.5969 -21.741 5.94749 +1522 4 43.2379 9.48961 15.149 2.99942 14.1859 3.68588 +1523 4 42.9802 11.0242 15.3396 -21.8087 10.2132 -10.2755 +1524 6 23.5302 5.07333 12.3088 -23.5628 55.8128 -25.3063 +1525 4 23.4112 4.1923 12.0373 1.19089 -49.3933 -5.08619 +1526 4 23.0178 5.53904 11.5656 24.5614 -12.3881 30.382 +1527 6 9.28539 15.401 4.24759 1.63269 -5.62651 -9.8947 +1528 4 9.02922 16.1115 4.82738 -12.4128 14.4693 4.40189 +1529 4 9.90895 14.9318 4.78697 15.8319 -9.58935 3.85081 +1530 6 26.711 10.8797 17.566 5.43365 -10.3343 -26.0937 +1531 4 26.4818 11.0142 18.4585 -6.06422 3.32013 41.5711 +1532 4 26.8019 11.7518 17.1937 0.341074 3.88847 -5.26754 +1533 6 26.0592 23.5875 33.6794 25.1455 50.9154 21.2543 +1534 4 25.4682 24.0785 33.1024 -8.24785 -6.01089 -9.80751 +1535 4 26.6604 24.3213 34.0779 -26.6739 -38.162 -12.8336 +1536 6 7.57385 10.4949 28.9097 -14.7972 2.07126 0.456687 +1537 4 6.75277 10.5859 29.4011 -5.17598 -12.8295 -3.89358 +1538 4 8.06091 11.2035 29.3139 24.0536 5.38729 3.77373 +1539 6 16.4953 16.9073 24.6459 13.4535 22.6993 31.6086 +1540 4 15.9363 17.7011 24.6942 7.46422 -1.49957 -9.096 +1541 4 16.1467 16.4045 23.9375 -12.5815 -17.1437 -28.632 +1542 6 12.5505 12.7927 0.441559 26.7797 -18.4986 61.4448 +1543 4 12.8902 12.7839 1.42408 -16.6807 15.1369 -51.7767 +1544 4 12.972 11.9767 0.117581 -17.3776 3.59908 -10.4186 +1545 6 6.80454 2.46926 9.04378 10.3033 -16.1572 19.5551 +1546 4 7.05376 2.92505 9.85651 -1.04006 9.78535 -3.84035 +1547 4 7.36555 1.67892 9.06596 -6.07141 -1.3767 -9.09165 +1548 6 28.8788 11.8454 12.005 47.3119 33.3239 7.75537 +1549 4 28.2175 12.4307 11.6211 -4.89696 7.77957 0.00959457 +1550 4 29.7805 12.2922 11.8721 -37.0304 -14.6121 1.30522 +1551 6 44.6756 32.5924 29.7091 -46.8228 -4.47104 18.0754 +1552 4 43.7214 32.9254 29.5641 42.8383 -8.78111 -1.84094 +1553 4 44.558 31.8742 30.3802 4.31467 20.1075 -17.1439 +1554 6 28.6099 15.1189 32.288 -8.09168 -64.7739 -6.10589 +1555 4 29.0591 15.887 31.9855 13.2175 18.1439 -15.8441 +1556 4 29.0109 14.3064 31.825 -10.272 37.9041 18.9788 +1557 6 1.13952 22.1955 33.6303 -59.4889 25.247 28.7943 +1558 4 0.675447 22.8098 33.0333 5.4615 -9.68619 7.91413 +1559 4 1.8611 21.9185 33.1521 52.5767 -22.4691 -40.0321 +1560 6 17.4529 16.8222 9.92046 -20.0761 -24.0842 48.1247 +1561 4 17.9341 17.1517 9.19999 21.5054 13.464 -32.8219 +1562 4 17.9802 16.1035 10.3295 -2.40424 8.44812 -14.2536 +1563 6 18.74 29.8021 14.3918 16.1488 4.65404 69.9188 +1564 4 19.5966 29.6355 14.8679 -24.5899 1.22938 -11.6521 +1565 4 18.9027 29.6655 13.4911 13.4763 -5.12933 -46.2854 +1566 6 39.4106 6.51176 13.0171 8.18439 9.54271 -9.98348 +1567 4 39.7968 7.3217 12.6105 -7.82756 -18.4389 5.68309 +1568 4 39.8965 5.76959 12.6221 -1.11983 7.69721 6.02388 +1569 6 54.1122 38.2735 14.316 -26.3921 15.7841 23.5556 +1570 4 53.5092 38.7211 14.9446 14.1224 -15.8084 0.476194 +1571 4 53.7657 38.6747 13.5269 5.67525 0.359642 -25.5906 +1572 6 7.51656 32.0218 20.9281 34.7748 10.0158 34.1931 +1573 4 7.08362 31.9253 20.1193 -22.6959 2.07513 -43.8223 +1574 4 7.03544 31.4175 21.4603 -12.2713 -14.4046 24.4342 +1575 6 26.9722 15.5137 13.836 8.2831 -9.07996 -12.1546 +1576 4 27.2905 14.6773 14.2204 -10.3825 7.39938 7.42218 +1577 4 26.0228 15.629 13.9568 -6.27371 -3.74993 11.5294 +1578 6 18.3731 16.4369 32.1258 -5.47484 6.15837 -16.1574 +1579 4 18.1737 16.7054 31.2071 -0.945967 -8.38127 9.44724 +1580 4 19.0036 17.0959 32.4159 12.6478 4.85619 3.13766 +1581 6 52.4904 31.6749 23.2282 -45.8236 3.94874 65.5164 +1582 4 52.5054 32.2301 24.055 -6.11863 -14.7847 -21.5508 +1583 4 53.2278 31.9578 22.7624 44.676 11.2926 -39.5338 +1584 6 2.17063 9.69676 28.2025 -10.599 22.0242 17.0864 +1585 4 2.41083 10.574 27.888 12.6445 -0.15763 -12.1006 +1586 4 1.36653 9.91172 28.7063 1.66945 -10.1846 4.32482 +1587 6 32.9295 0.084333 22.579 -26.8721 -17.4052 -13.8633 +1588 4 33.2309 41.109 22.2818 0.690852 17.8844 8.89147 +1589 4 33.6446 0.598803 22.932 23.7791 -0.031599 0.0852179 +1590 6 20.7171 41.5453 38.643 51.9522 19.855 -62.1487 +1591 4 20.0643 41.0408 39.0691 -29.2365 -22.9372 13.5286 +1592 4 20.9788 41.0468 37.7869 -12.0924 18.2625 49.3819 +1593 6 43.2965 24.3242 12.1559 29.4143 27.7167 -28.3716 +1594 4 43.2964 25.2918 12.2975 -10.3211 -14.9579 7.88207 +1595 4 44.0244 24.2792 11.4826 -12.2932 -11.2644 22.4039 +1596 6 22.0333 36.2992 11.8143 -17.8744 11.1706 -5.23693 +1597 4 21.6038 36.9407 11.2131 12.0614 -9.84488 11.7859 +1598 4 22.8639 36.0559 11.3996 4.49067 -2.6397 -1.6843 +1599 6 50.7446 20.5307 30.3299 -19.4296 24.1009 0.394401 +1600 4 50.3769 20.0585 31.0978 -4.60399 -0.499453 -6.82258 +1601 4 50.1204 21.2977 30.1594 19.9431 -26.9935 4.34337 +1602 6 20.8379 3.84934 18.1872 -10.63 2.24574 17.9634 +1603 4 21.6372 4.15439 17.7675 6.81748 4.13844 -2.44268 +1604 4 20.7537 4.31685 19.0447 1.53322 -4.30004 -12.0579 +1605 6 4.001 20.6421 6.99361 -18.7611 -9.71733 3.72301 +1606 4 3.09723 20.6004 6.53941 30.5715 -8.65918 22.3858 +1607 4 4.00786 20.2035 7.89591 -15.2068 14.2544 -28.772 +1608 6 11.948 15.4413 41.4409 9.86263 -45.3449 -5.39948 +1609 4 11.9713 14.4541 41.6361 -2.32711 35.624 3.02695 +1610 4 12.4708 15.4889 40.6181 -5.28805 11.0492 6.42 +1611 6 3.00764 18.5435 38.9252 6.90717 -29.584 40.0663 +1612 4 3.56523 17.7255 38.8717 -9.75827 16.9893 -1.25399 +1613 4 2.92934 18.9138 38.0721 -1.66709 15.3109 -35.9518 +1614 6 8.5978 38.8858 11.3072 48.4025 32.5603 4.46589 +1615 4 9.44036 39.0024 10.7943 -20.5341 -1.07382 9.55064 +1616 4 8.19448 38.1327 10.9484 -22.3544 -46.6733 -17.9601 +1617 6 12.9691 33.9778 38.4933 34.8069 -13.3685 -21.4899 +1618 4 12.6573 33.2385 37.9471 -9.06758 1.22663 10.2849 +1619 4 13.9307 33.983 38.2659 -20.4066 10.3952 14.8996 +1620 6 4.69069 11.9902 6.04709 5.57568 0.955193 2.63183 +1621 4 3.83092 11.6207 5.79405 1.19943 -2.71585 -3.65246 +1622 4 5.36696 11.7708 5.36999 -19.9658 -4.94035 2.87891 +1623 6 10.8381 15.9154 25.2196 -36.4648 2.02786 -4.38258 +1624 4 11.7191 16.2167 25.3262 31.8449 11.9168 5.4517 +1625 4 10.3518 16.6682 24.8476 5.65772 -8.76316 -0.529027 +1626 6 20.7604 3.23767 6.55488 4.15603 28.9608 0.670607 +1627 4 20.2106 2.56517 6.18958 -7.79877 -24.0058 -5.45951 +1628 4 20.2434 4.04703 6.45055 -2.36445 1.41903 2.77062 +1629 6 47.6381 39.1588 31.2153 -11.506 28.7103 -40.9212 +1630 4 46.7125 39.0803 30.8864 16.1685 3.01672 12.9065 +1631 4 48.0161 39.883 30.6238 -10.851 -36.2784 24.6994 +1632 6 8.33868 27.7571 27.6932 -33.938 3.65348 13.4266 +1633 4 7.90796 26.9962 28.1436 6.90464 18.5991 -0.450451 +1634 4 9.05762 27.3551 27.2376 19.8804 -10.068 -12.1598 +1635 6 33.245 40.3099 33.4253 18.3517 22.2199 -28.9554 +1636 4 32.5937 41.0038 33.2194 0.94932 -12.4457 9.89811 +1637 4 33.9479 40.492 32.7526 -7.59275 -9.33057 17.0692 +1638 6 24.5058 34.6327 27.2588 -1.70215 14.4876 -27.3243 +1639 4 24.8356 35.5409 27.0166 -5.53884 -24.0927 13.0812 +1640 4 24.1351 34.315 26.3934 7.47117 3.95694 29.9195 +1641 6 13.3256 36.76 35.7403 23.371 22.3884 -21.319 +1642 4 14.292 36.6204 35.8687 -19.0607 -2.42845 14.454 +1643 4 12.8134 36.0651 36.1242 -8.79549 -23.1532 9.33092 +1644 6 34.0568 20.1616 33.2139 18.2744 1.49148 -3.34215 +1645 4 34.901 20.3965 32.7524 -27.9907 10.0382 9.43414 +1646 4 33.5726 20.9405 33.5892 13.555 -8.0917 -8.63642 +1647 6 22.8329 33.5616 31.6214 -12.6844 15.5573 -21.5595 +1648 4 23.5755 34.1858 31.5969 1.53708 -3.14405 -0.637663 +1649 4 23.0292 32.8658 32.2325 13.4469 -12.4025 17.113 +1650 6 23.7434 2.42786 19.8498 9.49596 22.5629 12.9133 +1651 4 24.532 1.90722 19.7117 15.1933 -8.07802 -2.32773 +1652 4 23.0629 1.99408 19.3682 -23.4605 -15.8437 -14.4607 +1653 6 10.59 1.63974 20.5169 -0.95575 -6.83071 6.14558 +1654 4 9.98705 1.03236 20.0473 7.71399 2.84727 3.14747 +1655 4 10.6246 2.47233 20.0276 -8.35822 1.7372 -3.87231 +1656 6 6.50082 24.8628 7.81243 5.63459 3.09475 -4.38693 +1657 4 7.40706 24.9537 7.44087 -14.825 -10.0154 1.3351 +1658 4 6.01351 24.1359 7.38457 10.3118 5.93376 -6.27471 +1659 6 54.7907 32.5298 25.4601 2.42441 14.1538 -12.299 +1660 4 54.0693 33.194 25.3949 12.697 -15.3913 -0.923548 +1661 4 0.387469 32.6052 24.6546 -22.4501 -0.197402 25.3904 +1662 6 6.24565 20.1804 28.9699 -20.0835 16.2671 13.5362 +1663 4 5.37616 20.2206 28.5173 17.3942 -4.89439 1.50138 +1664 4 6.85708 19.7029 28.4106 5.94408 -11.9876 -6.03836 +1665 6 50.061 21.6087 11.3404 -11.515 44.0552 -42.0488 +1666 4 50.9725 21.751 11.0493 2.56545 -3.3262 -1.97817 +1667 4 50.0662 20.9568 11.9903 8.13397 -42.2403 36.0281 +1668 6 43.4741 33.5215 19.648 39.1267 -7.16957 -40.9914 +1669 4 43.8052 33.5504 20.5247 -1.27694 2.64583 28.8889 +1670 4 42.5461 33.5822 19.6063 -36.855 5.29583 12.3512 +1671 6 30.8225 7.19458 41.0729 -33.0718 18.8928 10.1641 +1672 4 30.0173 7.64992 40.6345 32.3343 -18.9847 22.962 +1673 4 30.7853 7.47469 0.131591 -1.52838 -8.42988 -38.7943 +1674 6 12.1264 25.8478 11.0965 -41.5825 -1.76886 -24.0951 +1675 4 11.2804 25.9828 10.5746 22.2453 -8.09118 27.7312 +1676 4 12.6111 26.6214 10.8799 25.9351 22.819 -1.42381 +1677 6 47.8207 5.82713 17.7363 28.7614 -16.7343 -8.46055 +1678 4 48.0335 5.15295 17.0353 -2.74159 24.5551 13.4979 +1679 4 48.6986 6.12754 18.0988 -19.3132 -4.26463 -8.98138 +1680 6 35.1697 12.9074 16.5814 -26.6969 23.1645 14.7724 +1681 4 35.331 12.9801 17.5341 9.94288 -5.95548 -5.31324 +1682 4 34.5116 13.6489 16.4838 18.7069 -22.8028 -11.189 +1683 6 10.4746 10.6344 33.9856 -30.1195 -20.4446 -6.31426 +1684 4 10.7944 11.3866 34.5009 -4.55531 -6.56386 0.452866 +1685 4 9.59186 10.377 34.349 25.6427 10.4215 -3.60637 +1686 6 9.86976 7.46809 9.66723 13.2706 -15.2427 -11.6817 +1687 4 9.07254 8.00079 9.6953 0.322066 10.4083 -1.78771 +1688 4 10.1027 7.29929 8.72005 -15.6005 8.2826 19.6359 +1689 6 11.1498 9.5629 29.1446 -4.60031 -6.3451 3.75047 +1690 4 10.6862 9.26798 29.9509 5.10767 2.07156 -10.4371 +1691 4 11.3249 8.76682 28.6116 2.75639 0.845127 6.4689 +1692 6 46.3982 12.7571 37.8973 13.0728 8.65129 -14.0384 +1693 4 46.6651 13.0033 36.9771 -6.5436 -6.98702 17.4091 +1694 4 46.8422 13.384 38.4935 -4.33131 -5.25976 0.421567 +1695 6 4.7745 19.0249 15.9997 -22.3762 2.96494 22.3523 +1696 4 4.16029 19.0173 16.7572 4.82074 7.85299 -8.34635 +1697 4 5.51792 18.5695 16.4006 17.242 -3.98645 -13.636 +1698 6 50.2756 39.8187 19.3535 -48.7732 -19.7782 -8.19609 +1699 4 50.1357 39.0812 19.9713 14.3147 6.83039 4.1366 +1700 4 49.4547 39.7468 18.7938 35.5854 8.27631 5.22634 +1701 6 3.57022 23.2982 26.3116 -7.21736 12.7853 -4.33091 +1702 4 3.04677 23.327 25.4841 2.15403 -9.28995 15.8001 +1703 4 3.1589 23.9918 26.8774 3.27351 -16.4313 -7.87876 +1704 6 43.3323 18.2357 20.5099 -9.76971 -1.121 -6.56922 +1705 4 42.7632 18.9863 20.7177 2.34101 2.93749 0.115163 +1706 4 43.9096 18.122 21.2711 1.48233 -4.92166 7.17918 +1707 6 14.4939 41.5272 19.7194 7.33174 -3.95938 -8.98841 +1708 4 13.9791 41.768 20.4704 -25.804 7.49044 14.4407 +1709 4 15.35 41.4773 20.1189 24.9681 -5.23262 -6.74673 +1710 6 29.2751 29.8624 26.915 55.5011 14.3278 -64.7852 +1711 4 29.462 29.6739 25.9095 -28.0317 9.76644 54.5148 +1712 4 30.1137 30.3565 27.1616 -29.5885 -20.0698 8.89328 +1713 6 6.32585 26.1455 11.5441 3.18215 15.5722 27.8672 +1714 4 6.22913 25.7559 12.4173 -5.87839 -9.43723 6.04013 +1715 4 6.88652 26.9071 11.7431 3.72153 0.148286 -16.8953 +1716 6 27.6581 9.23325 15.2376 24.6795 20.4415 1.81178 +1717 4 28.3906 9.86787 14.9946 -20.7277 -22.2866 6.02651 +1718 4 27.7257 8.49599 14.6233 3.42822 -3.8556 -2.27597 +1719 6 29.7826 38.0629 17.0951 -21.7625 -1.10982 -31.3954 +1720 4 29.5447 37.2807 16.5438 11.5646 7.7876 16.1146 +1721 4 29.1666 38.7512 16.7768 9.10566 -6.75007 12.2127 +1722 6 52.2237 28.7307 4.26632 40.7154 12.5569 -19.536 +1723 4 53.094 28.6942 3.75761 -25.982 6.02481 23.1744 +1724 4 51.8384 27.8718 4.17524 -3.40498 -27.0863 -4.04919 +1725 6 17.1651 16.6761 6.10093 10.0081 29.999 -15.4838 +1726 4 17.0645 17.5224 6.60658 -3.46995 -23.4179 -4.25622 +1727 4 16.9429 15.9406 6.65512 -3.52922 -13.7209 19.1007 +1728 6 36.6584 7.55275 33.426 1.51046 -27.4434 34.6673 +1729 4 36.0562 7.00422 33.9909 9.38132 12.247 -13.9906 +1730 4 36.0891 7.78594 32.7139 -15.8398 12.8789 -25.2624 +1731 6 26.1693 3.13272 9.58463 26.4836 36.1065 -53.3475 +1732 4 26.5189 3.61335 10.3026 12.8321 10.8542 33.1136 +1733 4 25.6805 2.43597 9.90138 -37.6231 -51.1462 30.1839 +1734 6 1.19232 17.1076 33.1734 0.722887 26.1228 -9.87087 +1735 4 1.0219 17.7977 32.4875 3.44775 -13.3597 11.6369 +1736 4 0.89275 17.4757 34.0242 -0.842403 -4.58413 -3.86686 +1737 6 29.175 10.1805 5.37687 2.48705 -7.47299 -1.58449 +1738 4 28.5307 10.3443 6.0806 2.54341 -1.49901 -0.102048 +1739 4 29.6529 9.35261 5.56356 -13.9845 3.47491 -0.693848 +1740 6 9.21964 21.135 0.193729 30.6013 -8.57211 -16.2038 +1741 4 9.93935 20.7152 41.5745 -5.21063 7.9265 20.924 +1742 4 8.4582 20.7874 41.6647 -18.4316 -1.36421 1.54976 +1743 6 7.41915 26.897 34.8578 6.273 24.0322 40.4596 +1744 4 7.07209 27.1094 35.7714 11.2799 -9.18849 -34.7736 +1745 4 6.87885 26.1925 34.5434 -18.5272 -22.724 -11.5995 +1746 6 18.6237 10.1563 3.02822 -55.9716 37.9013 1.68891 +1747 4 17.9823 9.44023 2.87563 14.9297 4.34306 1.98909 +1748 4 18.009 10.9755 3.18254 40.8652 -32.8317 -2.61569 +1749 6 13.1455 21.2337 25.2154 -14.3081 5.93545 -14.9534 +1750 4 12.8153 21.6822 24.4216 9.6722 -4.26313 4.93127 +1751 4 12.7862 20.3541 25.1726 -3.49479 -14.4912 -0.313259 +1752 6 4.91031 24.4198 40.532 -13.7809 -26.5024 -53.169 +1753 4 5.65778 24.4539 41.0894 26.3299 12.2697 26.6549 +1754 4 5.26856 23.9753 39.7091 -18.4358 16.5303 24.5031 +1755 6 54.7198 6.2862 9.93073 18.558 2.67796 -18.7732 +1756 4 54.1336 6.00192 10.611 -15.308 -5.80798 23.6242 +1757 4 0.005563 7.17106 10.1764 0.43073 7.36928 5.10877 +1758 6 51.7604 16.6436 19.3877 -20.3234 -7.55047 -14.8495 +1759 4 51.6779 16.1639 18.5383 1.1676 14.9854 4.84802 +1760 4 52.2077 17.4816 19.2574 16.3674 3.30585 -9.00164 +1761 6 38.6218 2.96001 13.0988 15.7387 3.67705 55.5859 +1762 4 38.6299 3.43096 13.9849 -4.06073 -12.9308 -23.724 +1763 4 38.2169 3.56793 12.5083 -12.8186 19.7945 -24.9943 +1764 6 19.4471 35.7007 9.61167 2.35324 -8.95281 6.35471 +1765 4 18.8335 36.2871 9.19379 -17.9936 2.63552 -14.7984 +1766 4 18.9495 35.3837 10.3842 8.56204 6.47345 -9.11173 +1767 6 46.9457 37.6212 25.7021 -15.6754 4.57489 10.5165 +1768 4 47.0239 38.0262 24.8354 11.6036 -0.197794 -10.4287 +1769 4 47.7281 37.1166 25.9279 8.14222 -0.129186 -6.11913 +1770 6 20.0249 17.2708 14.7582 9.34392 -2.11639 -6.02108 +1771 4 19.1723 17.4786 15.1706 12.7461 -0.873648 3.80655 +1772 4 20.7009 17.0069 15.4035 -13.3418 2.74043 0.572405 +1773 6 24.7358 29.2923 3.78206 18.5642 -33.4808 -47.1325 +1774 4 24.7422 28.3915 3.3709 -13.1038 11.8323 28.3161 +1775 4 25.3506 29.6775 3.14782 -2.77927 21.1078 10.4189 +1776 6 3.43141 8.92567 6.82668 25.8011 -1.75535 29.9445 +1777 4 3.08486 8.82716 7.75964 16.0017 4.22665 -30.6726 +1778 4 4.42441 9.10783 6.89545 -42.5611 -5.30748 1.54274 +1779 6 17.4891 30.59 19.7026 37.1524 -11.5388 -6.241 +1780 4 18.4343 30.3591 19.4199 -38.2372 10.1448 10.4771 +1781 4 16.9657 29.7875 19.5831 -4.14236 3.18225 -9.29444 +1782 6 13.2748 16.1833 39.0603 8.39615 -10.6604 2.01333 +1783 4 13.778 16.9491 39.3364 8.93523 3.59341 7.63718 +1784 4 12.5498 16.5465 38.5646 -17.693 7.52452 -10.3405 +1785 6 23.8419 27.9652 11.5971 -29.0622 15.8949 5.8355 +1786 4 23.0433 27.5239 11.9581 15.8216 -1.64981 -8.50246 +1787 4 23.6687 28.8945 11.8451 9.38175 -9.8305 -3.59643 +1788 6 14.4582 24.411 21.2251 -13.2323 27.0215 19.0701 +1789 4 13.9163 25.2229 21.3861 13.2503 -9.35589 -12.2275 +1790 4 14.348 23.9323 22.0593 -1.27999 -3.95586 -5.82862 +1791 6 46.6209 15.1404 22.2877 -21.0909 8.30909 34.5316 +1792 4 45.8336 14.7024 21.9608 7.3328 -3.88381 -14.3297 +1793 4 47.2246 15.4169 21.6106 10.5055 -5.27886 -22.0515 +1794 6 19.1453 29.7169 11.8746 -27.0123 -18.8736 -35.9167 +1795 4 18.7667 30.5363 11.5796 10.8323 29.6783 4.39578 +1796 4 18.5214 29.1838 11.3275 23.3568 -13.7991 20.8336 +1797 6 36.9132 18.8016 27.615 -17.0652 -23.8487 30.8874 +1798 4 36.4034 18.4868 26.8464 6.26881 1.65463 6.80847 +1799 4 36.6041 18.1666 28.3506 10.215 31.7365 -33.4968 +1800 6 35.8839 17.5137 25.5036 -5.81764 30.7264 -16.7466 +1801 4 36.5665 17.9094 24.9 -10.7703 -22.5287 9.19997 +1802 4 35.9135 16.5474 25.44 8.68204 5.15754 -2.43364 +1803 6 8.04468 41.8981 31.5366 26.4021 9.77217 -3.38911 +1804 4 8.66886 41.284 31.9946 -24.4733 15.0027 -13.0466 +1805 4 8.60227 0.704634 31.1522 -11.4596 -14.2431 6.13083 +1806 6 31.7024 34.8356 17.9299 26.5575 -27.0845 -4.88708 +1807 4 32.6196 34.4986 17.7931 -22.3662 0.836155 -3.84042 +1808 4 31.9071 35.6664 18.3392 -5.09232 26.8034 6.09861 +1809 6 22.0993 41.0535 5.13739 10.0927 40.3608 -89.4928 +1810 4 22.1435 40.6782 5.94278 2.96748 -46.7441 88.004 +1811 4 22.8097 40.6452 4.60918 -8.49191 2.25551 6.5005 +1812 6 11.6188 5.17183 29.5438 -37.4391 -17.3681 45.4318 +1813 4 12.0782 4.3477 29.7115 12.4576 1.56532 -11.0695 +1814 4 10.8376 5.06958 30.1835 21.3256 14.0691 -33.8944 +1815 6 13.0142 9.45267 21.0738 -17.3871 -39.5803 -33.4019 +1816 4 13.648 9.91302 21.5572 37.1542 33.3127 26.6408 +1817 4 13.4951 8.71823 20.6397 -14.9934 11.5246 2.17133 +1818 6 12.4259 4.16416 0.171584 25.5917 58.0572 -18.9009 +1819 4 12.7038 3.75631 0.988868 -0.121161 -3.62646 8.37405 +1820 4 12.9914 5.02921 0.073462 -27.1162 -49.1387 2.0493 +1821 6 45.1548 14.6294 28.1056 43.5869 -15.7342 -2.79686 +1822 4 45.3799 14.9442 27.2254 -14.4652 2.82802 -6.08545 +1823 4 46.001 14.1543 28.294 -26.1128 6.03561 5.66217 +1824 6 52.5819 19.2522 0.880939 -13.6546 -24.4625 3.21793 +1825 4 52.4967 19.3157 41.8353 6.16951 -6.72877 -2.3034 +1826 4 52.7342 20.1258 1.1855 8.55196 28.2584 6.16427 +1827 6 0.17636 18.5769 30.5692 -13.5341 -21.3209 11.3545 +1828 4 0.97347 18.6538 30.0344 3.16555 8.74201 -0.550561 +1829 4 54.7381 19.4288 30.6755 1.51483 11.9419 -1.05075 +1830 6 17.6474 28.1849 1.96582 -3.95698 7.79984 2.09024 +1831 4 17.0036 28.8884 1.72628 7.01161 -11.1903 7.18073 +1832 4 17.5665 28.0879 2.93205 1.48476 5.36119 -8.9874 +1833 6 22.5179 30.1562 5.01973 -0.557011 13.5756 -11.2394 +1834 4 23.053 30.1464 4.21842 7.71181 1.56353 5.86697 +1835 4 22.1417 29.2826 4.9966 -11.5089 -8.75783 6.0437 +1836 6 11.3992 8.80614 17.6425 18.8049 17.2909 -5.92301 +1837 4 12.0044 8.1818 18.0403 -8.94801 -14.7479 17.6102 +1838 4 12.0653 9.44286 17.3244 -18.8797 1.15675 -4.46111 +1839 6 32.2825 3.5901 26.8335 38.6865 42.7422 0.354813 +1840 4 31.9744 3.38447 25.9652 -16.937 -9.17442 -22.5821 +1841 4 32.8531 4.41036 26.697 -18.7333 -32.0278 -1.10411 +1842 6 26.8283 37.1448 15.664 9.9544 44.9512 -6.81835 +1843 4 26.832 37.6522 16.5019 -4.80771 -22.2764 -7.00776 +1844 4 26.708 36.2069 15.7377 -4.77442 -21.1488 11.5765 +1845 6 22.9466 3.40402 22.281 26.551 -3.46013 -1.27592 +1846 4 23.3626 3.00539 21.4748 -15.0613 6.75 14.6032 +1847 4 23.702 3.67884 22.8406 -14.5661 -4.86975 -12.1571 +1848 6 14.6187 28.2219 5.2011 12.2375 -1.31522 5.54773 +1849 4 14.146 28.1316 4.37141 -5.71124 1.87741 -8.30492 +1850 4 14.2863 29.0052 5.66137 -0.824291 -0.470469 -2.06805 +1851 6 20.2555 37.1856 16.5486 -24.9193 16.4856 21.7008 +1852 4 21.0596 37.4718 16.144 26.6499 6.5165 -11.4453 +1853 4 20.1477 37.8155 17.2956 -4.48599 -12.7862 -6.90992 +1854 6 17.9469 28.5629 23.8891 26.0841 -15.2841 -12.8531 +1855 4 18.7956 28.2639 23.4837 -20.5944 5.95667 14.8805 +1856 4 17.3322 27.8283 23.7208 -3.07308 9.52654 -1.59768 +1857 6 33.6454 24.2344 25.2281 6.08515 -19.3492 9.67379 +1858 4 33.7229 23.2583 25.1621 -7.7165 13.5894 -11.682 +1859 4 33.9838 24.3464 26.1231 0.527101 9.69022 -3.14208 +1860 6 9.99248 17.6305 2.22889 -2.94775 -31.1618 -12.577 +1861 4 10.7668 17.5307 1.6348 -7.17319 1.58445 12.7603 +1862 4 9.8062 16.7546 2.64219 6.61617 15.6433 -4.64734 +1863 6 24.3378 36.7975 8.92134 10.0949 -17.5556 18.6285 +1864 4 24.0798 37.5812 8.46711 -7.4438 24.0622 -5.98172 +1865 4 24.7733 37.0584 9.7453 -6.84359 -4.10885 -5.58351 +1866 6 14.3929 4.30304 27.7402 56.7365 -3.53996 19.7179 +1867 4 15.3546 4.44499 27.4586 -37.3153 -7.57895 7.00929 +1868 4 13.8272 4.37832 26.9899 -16.116 5.01688 -19.8092 +1869 6 13.2096 25.4586 35.3298 -3.87145 -6.51473 -10.8119 +1870 4 13.1476 25.2267 36.278 -1.83966 -3.78777 -13.8323 +1871 4 12.5545 24.9939 34.7684 5.09589 5.85633 19.2997 +1872 6 43.7315 33.1816 24.4051 17.2004 -9.02075 24.8986 +1873 4 44.3591 33.0681 25.1678 -20.1541 -6.26738 -17.3644 +1874 4 44.1096 33.9146 23.9227 -1.6352 8.32092 -8.69406 +1875 6 6.97009 30.4077 7.13769 23.121 1.43384 34.0809 +1876 4 6.71282 29.9591 7.9596 7.06976 3.62274 -2.26904 +1877 4 6.20421 30.2819 6.61977 -27.9511 -2.76807 -27.2062 +1878 6 44.437 39.4145 21.7835 -9.43682 11.6365 -18.5611 +1879 4 43.878 39.1032 21.0489 1.92512 -11.9494 17.5009 +1880 4 44.878 40.1639 21.3648 8.44417 -6.89071 6.17346 +1881 6 1.1648 16.4475 24.9778 -2.61131 5.39938 13.1681 +1882 4 1.07525 17.0286 24.1819 -7.88043 -13.0173 22.3573 +1883 4 0.434843 16.5677 25.6378 18.4556 1.9359 -28.7216 +1884 6 8.16988 33.8361 10.6637 16.6829 23.9256 47.7562 +1885 4 8.49559 33.5478 9.83195 -4.50358 -22.2449 -29.7436 +1886 4 7.35799 33.4028 10.9227 -18.4601 -13.1254 -8.86092 +1887 6 45.3716 15.8699 40.491 -6.36942 -3.03704 -2.15917 +1888 4 44.5133 15.7719 40.0601 4.63234 -6.98635 -0.416374 +1889 4 45.243 16.6248 41.0649 5.7116 1.92459 5.42472 +1890 6 38.7776 4.29245 15.9056 11.0795 0.30753 4.41463 +1891 4 39.6766 4.00679 16.0952 1.69097 -2.92337 -3.33067 +1892 4 38.5504 4.73291 16.7401 -7.14778 -2.92142 -9.36231 +1893 6 21.0846 9.20759 23.9691 5.60032 -0.18462 4.18544 +1894 4 20.9445 8.65571 23.1711 -3.69603 16.8592 7.46004 +1895 4 20.5672 10.0363 23.9442 1.93643 -14.5945 -11.3561 +1896 6 6.46938 36.1391 20.0069 4.0004 4.10087 4.13062 +1897 4 5.99357 35.3124 19.8297 -2.3473 7.0562 -2.30419 +1898 4 7.3052 35.893 20.4098 -0.600933 -5.92452 -3.30983 +1899 6 17.7588 23.4635 11.2444 16.528 -28.2646 53.7307 +1900 4 16.9432 23.8548 11.0264 -32.805 26.4079 -23.7501 +1901 4 17.621 23.3206 12.2167 9.32529 -0.814156 -28.2078 +1902 6 2.23938 39.2705 23.5372 32.4488 -19.3396 -21.3039 +1903 4 2.96143 39.1072 24.212 -19.8533 -4.03587 -26.9428 +1904 4 2.57592 39.0525 22.6024 -11.4643 11.6849 46.2914 +1905 6 21.7189 10.3135 3.08585 -2.90529 19.7604 61.578 +1906 4 21.843 10.1221 2.19424 -0.974385 -17.6276 -55.1642 +1907 4 20.7734 10.4085 3.28686 2.80557 -4.86174 -11.6796 +1908 6 13.3371 37.6485 26.8148 34.7445 -2.08205 -3.58175 +1909 4 12.7942 37.01 27.2655 -5.666 -15.7112 8.11946 +1910 4 14.1995 37.1812 26.5945 -31.1056 12.6209 6.4215 +1911 6 45.679 9.86525 8.82671 -1.22844 -5.97168 -0.0165319 +1912 4 45.3204 9.57969 7.98479 1.29945 7.51218 -9.52666 +1913 4 45.2548 9.27624 9.44517 -6.37871 -3.09075 9.62419 +1914 6 39.8117 32.343 29.5858 -3.04799 14.0722 -9.88422 +1915 4 39.6223 31.4471 29.2796 3.58631 -7.81261 7.71305 +1916 4 40.3439 32.3214 30.3816 0.770365 -10.1242 2.16071 +1917 6 39.1301 32.1592 8.96473 45.9624 -7.76569 -23.2306 +1918 4 39.6852 32.0596 8.1252 -31.4186 4.60772 35.1501 +1919 4 38.2007 32.2042 8.75798 -9.66602 0.778467 -8.76952 +1920 6 29.7501 11.3103 40.3404 42.6438 -12.6008 -10.1865 +1921 4 29.0692 10.6634 40.5326 -1.99158 -8.72077 -0.363163 +1922 4 30.6164 10.7842 40.3158 -34.6338 15.486 -0.0451708 +1923 6 24.8345 19.8801 29.8412 -7.59088 37.7695 16.0848 +1924 4 24.9026 19.0378 30.268 -1.65451 -21.4471 9.48031 +1925 4 24.5694 20.5293 30.547 8.64688 -23.6335 -15.2845 +1926 6 50.0799 29.4689 2.86832 11.3398 7.37373 -14.0975 +1927 4 50.7937 29.3382 3.51213 -5.95266 6.62042 -8.33887 +1928 4 50.5172 29.4209 1.98721 -16.9062 -3.16045 21.5768 +1929 6 26.3158 13.2487 37.9516 44.6834 6.62304 1.7852 +1930 4 27.2667 13.2121 37.7291 -19.4356 -10.4808 -19.3263 +1931 4 26.4654 13.336 38.8817 -25.2145 10.5198 25.1195 +1932 6 24.3285 13.817 16.1492 -2.87417 -29.0242 -9.8062 +1933 4 24.8278 14.0306 16.9324 2.95884 13.8503 11.1204 +1934 4 24.1796 14.5912 15.6032 1.91347 13.6823 2.96602 +1935 6 21.9624 25.0824 8.00452 15.4008 12.078 14.6814 +1936 4 22.598 25.7039 7.58094 -6.50256 -15.9793 3.04336 +1937 4 22.4506 24.6482 8.74092 -7.92214 9.81208 -17.5113 +1938 6 50.1646 25.295 29.0323 7.20414 -13.325 -13.2678 +1939 4 50.9752 25.188 28.522 -3.46618 -9.57224 -11.582 +1940 4 50.4808 25.9292 29.6536 -4.58067 20.151 23.6328 +1941 6 23.186 6.81871 7.63171 8.52809 43.4321 -4.70249 +1942 4 24.005 7.36604 7.81791 -26.2659 -19.6382 -4.15731 +1943 4 22.4749 7.49932 7.50679 12.9101 -23.886 0.0924589 +1944 6 6.93738 5.85096 20.8328 -1.25739 23.0019 -5.42089 +1945 4 7.49016 6.65136 20.6793 -8.05782 -22.0664 2.33926 +1946 4 6.43567 5.73489 20.0135 6.68134 -11.6114 -0.0369962 +1947 6 25.4027 39.7503 23.9523 -6.31967 32.2782 -31.5462 +1948 4 25.6215 38.8259 24.0292 3.86532 -10.8289 -5.32001 +1949 4 25.5293 40.0494 22.9984 1.78505 -20.5244 33.6821 +1950 6 10.8465 30.682 2.12076 -14.9417 -4.95607 29.3443 +1951 4 9.91334 30.8811 2.27771 3.65307 -4.25506 9.47201 +1952 4 11.0492 31.2188 1.38489 10.4343 12.2811 -36.8692 +1953 6 23.0846 40.5263 40.0577 -14.1833 12.856 -13.2149 +1954 4 23.7732 40.7716 39.4116 -4.4893 -4.99974 3.24897 +1955 4 22.2685 41.0049 39.7737 14.5189 -12.3092 -2.05606 +1956 6 29.2062 28.3669 37.5673 -46.9973 46.4688 -26.4511 +1957 4 28.2092 28.447 37.3765 47.4284 -5.55714 9.99444 +1958 4 29.3363 27.5265 37.9547 9.31284 -31.0764 15.334 +1959 6 1.86163 12.1711 18.0765 -5.91003 5.49035 -5.71632 +1960 4 2.55659 11.9166 18.6527 25.6221 -14.4574 8.12849 +1961 4 1.26079 12.5379 18.7153 -20.6967 6.08864 -3.03965 +1962 6 35.8475 14.1052 8.57203 -21.6385 -0.893463 -33.3774 +1963 4 35.1968 13.4152 8.63145 -9.00219 -13.9675 31.2536 +1964 4 35.5915 14.3843 7.67264 23.8052 12.2531 2.11843 +1965 6 9.47935 39.8135 37.5891 59.0759 6.31763 -30.1219 +1966 4 10.4266 39.6693 37.2666 -35.8633 -8.68454 26.4626 +1967 4 9.26489 40.5592 37.0217 -20.4655 -4.29881 5.22341 +1968 6 3.55142 30.3339 19.2713 -4.86381 -1.52132 15.3498 +1969 4 4.33638 30.9045 19.2209 2.57405 -7.87202 3.73908 +1970 4 3.61239 29.7873 20.0935 6.99099 14.0083 -17.3235 +1971 6 36.3358 32.3745 17.56 -88.747 -21.2483 -18.3477 +1972 4 37.1123 32.7301 17.855 71.5568 29.0637 22.2427 +1973 4 36.4955 31.7908 16.8209 7.92507 -6.87638 -5.35096 +1974 6 22.0663 24.5107 41.4102 10.2987 16.3962 12.7497 +1975 4 21.8202 25.2352 0.099599 7.35269 -2.74787 -1.24985 +1976 4 21.4331 24.5495 40.7007 -15.7672 -0.145359 -12.6123 +1977 6 45.7559 15.6146 11.6534 9.54961 -0.52573 -11.8143 +1978 4 46.6616 15.9476 11.7359 -2.85604 3.39399 3.95489 +1979 4 45.8337 14.6574 11.6049 5.18085 -12.4794 -2.56515 +1980 6 22.3677 20.3608 16.0248 -8.43349 0.762232 -3.33301 +1981 4 21.8453 20.4382 16.8206 -16.1556 -9.64869 10.2413 +1982 4 23.0114 21.0388 16.1556 20.3116 20.3082 3.24798 +1983 6 25.8272 25.7408 18.9039 -4.38174 23.1082 -8.64826 +1984 4 25.2526 26.4897 18.6396 10.1677 -11.9346 2.39614 +1985 4 25.327 25.3554 19.6213 -1.60311 -10.6753 3.35926 +1986 6 35.3217 34.2027 33.2895 -15.2368 -41.9721 4.95923 +1987 4 35.4982 35.1152 33.2737 3.10328 43.0158 -1.14622 +1988 4 34.4946 34.1251 33.8 0.780353 -3.85018 -10.6306 +1989 6 39.2773 17.1161 17.3873 -13.1248 -32.2738 -8.05101 +1990 4 39.9918 17.6798 17.5739 28.094 23.6652 8.23643 +1991 4 38.688 17.6273 16.829 -11.1713 3.07886 5.75329 +1992 6 0.390078 14.9382 21.7871 11.1367 4.76555 -0.935352 +1993 4 54.4387 14.8735 21.5807 -4.47162 2.48431 -1.07762 +1994 4 0.539841 14.2564 22.4568 -0.558284 -6.24417 -4.29591 +1995 6 15.9777 23.2264 17.7728 8.65625 13.1041 -6.34263 +1996 4 15.4566 22.9884 16.9791 5.52796 1.00784 5.82867 +1997 4 16.2806 24.159 17.6616 -10.6082 -13.1932 5.11686 +1998 6 5.23931 11.1231 17.5575 35.8701 -10.5445 17.9772 +1999 4 4.9182 10.2425 17.6538 -30.0926 -10.858 -8.95801 +2000 4 6.0864 10.9521 18.0214 -7.64643 27.0942 -5.06777 +2001 6 9.32885 36.7248 13.2722 18.9931 -22.2768 -8.23823 +2002 4 9.60165 35.7781 13.2295 -3.69965 14.6724 -0.704445 +2003 4 9.76236 37.1699 12.5317 -7.58045 -2.70049 0.515103 +2004 6 25.4778 33.5648 0.584885 -10.5355 67.2754 -12.4068 +2005 4 25.5984 34.5208 0.879361 -11.6997 -30.6233 -9.64051 +2006 4 26.086 33.1118 1.1181 20.4991 -31.2317 29.3626 +2007 6 17.3118 24.383 31.3319 -1.28664 6.54307 -2.76395 +2008 4 17.7194 25.1777 30.9449 -5.40799 -4.17061 0.343513 +2009 4 16.6541 24.6578 31.9842 -4.89885 3.77294 -0.581941 +2010 6 50.5608 32.7082 27.7934 4.54158 -2.94952 -18.7634 +2011 4 50.7453 32.9177 28.6973 0.494052 11.2961 18.8161 +2012 4 49.6536 32.9735 27.676 -15.0266 -0.0998574 -2.84245 +2013 6 2.26734 37.236 16.1173 -6.42813 -12.7591 -21.9136 +2014 4 3.23226 37.3187 16.1136 -7.03488 -2.64717 4.42174 +2015 4 1.90002 37.4962 16.9584 8.86323 8.39289 12.7736 +2016 6 25.781 33.1953 8.40059 -29.5389 -21.3471 9.61313 +2017 4 24.912 33.1588 8.86731 13.6407 4.32372 -10.5279 +2018 4 25.7521 32.4014 7.84509 3.14784 4.30114 -1.53431 +2019 6 24.7803 7.83271 25.42 33.5144 32.018 13.9598 +2020 4 25.5535 8.29724 25.0002 -28.4293 -10.6828 16.5011 +2021 4 24.3491 7.42211 24.7041 -24.9556 -17.4551 -27.4815 +2022 6 44.0168 27.3303 21.5604 -2.1935 -26.0293 -25.9567 +2023 4 43.1804 27.7287 21.7105 -15.5436 25.6402 11.6584 +2024 4 43.7182 26.5374 21.0766 16.4483 6.01939 6.04345 +2025 6 20.8314 32.075 6.72772 34.1297 -23.9008 -4.85338 +2026 4 21.613 31.4679 6.7544 -19.7741 14.5872 -14.4381 +2027 4 20.6476 32.1788 7.6576 -7.69651 14.1485 11.3249 +2028 6 0.619789 26.0994 3.99415 -10.3518 14.1264 10.767 +2029 4 0.887335 25.4928 3.30986 5.36048 -13.1936 -7.97543 +2030 4 1.24971 25.9998 4.71308 0.85353 -1.82089 -1.56654 +2031 6 23.69 0.227417 22.8544 35.0871 1.11343 17.3571 +2032 4 23.3906 1.11513 23.0752 -8.28129 -2.57498 -6.74336 +2033 4 24.6181 0.214091 23.2237 -29.0994 -2.98435 -11.3486 +2034 6 35.6339 26.9438 6.46453 10.8918 50.3879 3.14258 +2035 4 36.2586 27.0344 7.19591 -3.09793 -24.7425 -0.485193 +2036 4 35.6905 27.8753 6.10871 -13.1004 -35.3011 6.52721 +2037 6 50.1792 7.09321 18.6927 -10.3798 0.485236 0.91939 +2038 4 50.7755 7.39768 17.9917 2.23399 -7.26744 -1.07457 +2039 4 49.6856 7.89728 18.8977 2.66313 1.30029 -2.34319 +2040 6 12.4725 14.8259 12.1994 -11.4238 -12.6169 14.8051 +2041 4 11.6664 14.488 12.6556 18.5487 5.78377 -7.93059 +2042 4 12.1518 15.362 11.4889 -6.75978 6.85562 -13.2996 +2043 6 52.4644 22.357 36.3266 1.29806 9.96622 10.4358 +2044 4 51.6029 21.898 36.3064 11.3287 0.910024 -15.7837 +2045 4 53.0734 22.0059 35.6434 -17.6122 -2.36697 5.80151 +2046 6 41.7741 11.4843 39.1248 -4.39753 -8.31887 -97.8346 +2047 4 42.1028 11.6824 39.9378 27.3537 17.7413 77.2645 +2048 4 42.4804 11.7867 38.4877 -22.5072 -9.73773 16.9601 +2049 6 13.8016 22.5118 39.1095 -61.9889 -17.7515 -30.6487 +2050 4 12.8197 22.2903 39.2632 45.6803 12.2331 1.0283 +2051 4 13.898 22.318 38.1378 10.5436 5.15112 27.5343 +2052 6 28.757 19.5278 21.8422 22.1809 -34.574 6.30338 +2053 4 29.5381 18.8977 21.7155 -30.335 22.4331 6.48321 +2054 4 28.5907 19.9346 20.9925 4.65837 4.37905 -10.6157 +2055 6 8.3499 21.6369 36.3971 -4.18721 -6.14707 -6.4426 +2056 4 8.67403 22.5346 36.3601 -3.60933 11.4321 4.1017 +2057 4 7.70004 21.5677 37.1222 1.54916 7.87236 -6.53046 +2058 6 39.9526 23.9745 15.2115 13.6309 -13.3423 -31.903 +2059 4 40.8439 23.5703 15.3899 -24.3155 14.8143 -11.3375 +2060 4 39.7878 23.9253 14.2154 4.70535 3.62281 36.021 +2061 6 8.1527 38.6897 22.5283 9.69445 13.3876 41.2978 +2062 4 7.76273 39.4363 22.0797 -11.7526 5.15604 -12.9046 +2063 4 8.4358 39.1168 23.3873 -5.25998 -17.8667 -18.7912 +2064 6 10.8496 20.1728 28.9641 16.4592 -1.26099 15.6701 +2065 4 9.98954 19.7606 29.0198 -7.88942 -4.93169 1.40711 +2066 4 10.9743 20.477 28.0788 -3.54014 6.836 -18.3013 +2067 6 36.8958 23.8215 41.8184 -11.2791 50.4956 -15.8947 +2068 4 37.6092 23.2626 0.106032 31.5333 -36.7229 14.8491 +2069 4 36.0533 23.398 41.8576 -15.1401 -19.7994 6.87638 +2070 6 23.7844 40.6753 33.3645 25.4398 -8.90266 -26.6636 +2071 4 23.0047 40.9559 33.8219 -17.4738 3.31201 10.6553 +2072 4 23.8864 39.707 33.5122 -4.88896 17.7845 5.86364 +2073 6 4.67086 19.2968 35.4027 23.2175 14.2952 24.1117 +2074 4 5.52557 19.1329 35.8895 -25.1286 -0.194605 -14.6261 +2075 4 4.47498 18.5363 34.8535 5.06934 -11.7578 -4.1199 +2076 6 9.45318 25.7818 10.8943 -12.0967 -8.54473 -2.48434 +2077 4 9.17249 24.8577 10.8042 5.18757 -1.88658 7.00696 +2078 4 8.69489 26.2739 10.5541 4.04726 3.8113 4.64502 +2079 6 27.2856 22.4903 13.6084 -4.27813 -9.26261 -11.4963 +2080 4 27.1477 21.7546 14.2243 0.799228 0.372191 -1.31996 +2081 4 27.4324 22.0688 12.7356 2.14896 10.5831 15.5277 +2082 6 41.0369 18.7679 23.2817 21.3973 -17.1333 -11.6606 +2083 4 40.4805 18.1775 22.7581 -1.93352 7.79722 7.02989 +2084 4 40.5302 19.4817 23.6332 -16.07 12.1618 6.58845 +2085 6 46.4867 28.3511 20.139 19.5633 -2.73425 79.1757 +2086 4 45.7489 28.0125 20.7058 1.11057 9.83041 -23.9354 +2087 4 47.2126 28.3766 20.859 -22.6454 6.05643 -47.0217 +2088 6 14.8422 15.3983 30.0672 9.57922 -13.7488 21.5316 +2089 4 14.7114 15.4303 29.1407 -5.18406 2.12307 -31.6519 +2090 4 14.4223 14.5569 30.327 1.67929 11.6926 7.32181 +2091 6 23.5155 24.7614 35.2027 10.8097 10.1661 11.7756 +2092 4 22.8249 25.3921 35.4883 8.74662 -8.07224 -2.50931 +2093 4 24.264 24.8574 35.8273 -14.1502 1.20627 0.95778 +2094 6 19.9045 24.2066 28.4368 -7.08314 38.6572 -15.5481 +2095 4 20.1199 25.09 27.9887 -7.53461 -31.417 18.3002 +2096 4 18.948 24.2479 28.615 8.77669 -1.27719 -1.90381 +2097 6 45.9703 7.63062 20.2339 -9.12647 -14.8446 45.7383 +2098 4 46.0314 7.87281 21.2057 4.66889 -10.1155 -32.2433 +2099 4 46.2124 8.39508 19.7344 6.23892 21.3693 -9.48098 +2100 6 38.0366 12.4686 8.28298 -82.8488 23.4696 -21.0017 +2101 4 37.3097 13.1608 8.47894 48.7672 -25.4087 1.47773 +2102 4 37.4891 11.9231 7.63396 42.6716 2.94367 19.7224 +2103 6 46.9352 18.181 8.45984 -29.3266 9.95329 16.0714 +2104 4 46.1825 17.5598 8.49993 9.84889 1.25457 2.04897 +2105 4 47.3911 17.9594 7.65971 14.7535 -7.6497 -21.4463 +2106 6 10.8592 13.9727 9.37152 -3.14543 -2.30259 -2.26695 +2107 4 10.3309 14.6626 8.91794 11.6563 -8.1882 2.6931 +2108 4 11.7607 13.9013 8.99546 -12.5287 13.781 2.06755 +2109 6 34.3902 5.43491 14.0826 12.6346 -17.837 -1.14204 +2110 4 35.1666 5.80709 13.6695 9.45544 21.1547 -1.41353 +2111 4 34.3397 4.58795 13.6148 -10.7305 -5.41844 9.88093 +2112 6 0.19016 0.223418 22.9526 3.77382 -24.7853 -3.01602 +2113 4 0.21308 41.6498 22.1069 2.59646 7.80057 12.2766 +2114 4 54.882 1.08863 22.7473 -12.4607 27.7599 -7.08256 +2115 6 40.9349 30.5562 37.8906 -27.573 -19.5948 34.9696 +2116 4 40.0494 30.8463 38.2359 23.4276 0.414778 -20.0189 +2117 4 41.1198 29.7844 38.4793 13.2677 19.1991 -19.1849 +2118 6 16.6358 17.3088 12.6818 26.7235 26.3695 -9.20965 +2119 4 16.2617 16.4703 12.4231 -8.92935 -8.7699 -0.695474 +2120 4 17.0088 17.6771 11.8494 -7.35458 -7.68048 15.4997 +2121 6 29.681 5.43286 24.7605 9.99716 1.48249 -7.0405 +2122 4 30.3348 5.91815 24.2382 -0.696307 0.629534 -2.6419 +2123 4 30.0075 5.55596 25.6632 -4.07672 -1.78023 1.29455 +2124 6 49.8902 0.287541 27.2058 21.9743 -13.7053 4.20571 +2125 4 49.8511 0.519591 26.2742 -5.37584 5.48457 -4.26768 +2126 4 50.7946 41.8257 27.2858 -12.157 4.98657 1.57708 +2127 6 31.2412 31.7366 15.2127 13.4193 29.9729 -4.01619 +2128 4 31.644 30.8863 15.3566 3.05611 -13.2507 6.82249 +2129 4 31.9953 32.37 15.1128 -22.0385 -12.9049 3.52444 +2130 6 35.7903 24.1511 16.9464 13.6459 1.10276 -6.74723 +2131 4 35.6731 24.9832 16.4455 1.01595 -13.8109 1.97492 +2132 4 36.7089 23.8312 16.7527 -22.9866 2.97508 8.81266 +2133 6 24.2751 4.63968 36.7374 -16.5997 -22.3051 -33.4925 +2134 4 24.7608 5.22686 37.2962 14.6544 10.0168 10.4919 +2135 4 24.7016 4.68474 35.8573 -7.94113 -0.389021 16.9181 +2136 6 17.5636 12.9031 3.65869 27.6744 1.86844 -28.0383 +2137 4 17.6858 13.5605 2.94059 1.9993 -16.4932 11.4828 +2138 4 16.8984 13.3068 4.18363 -27.8054 1.98581 18.3397 +2139 6 4.17446 14.2934 18.2709 12.2351 -24.5699 -15.5283 +2140 4 4.25201 13.3082 18.1842 -5.45348 23.7329 4.34334 +2141 4 3.28482 14.5076 18.5604 -13.4286 -3.54266 5.37394 +2142 6 19.1793 36.8557 22.3908 -6.26797 4.12828 -2.16449 +2143 4 18.7803 36.3059 23.064 -4.74301 -7.71326 18.3965 +2144 4 19.5341 36.2254 21.7686 7.87239 -11.0625 -9.31555 +2145 6 15.659 11.9578 13.1999 9.98626 24.0921 3.91449 +2146 4 15.6233 12.8387 12.7526 3.08695 -23.3335 12.0049 +2147 4 16.532 11.8904 13.6603 -13.5492 -1.68197 -15.0215 +2148 6 24.7583 21.9129 5.36621 -52.0449 4.43235 28.4012 +2149 4 24.9756 21.6947 6.28233 10.5491 3.37037 -1.58044 +2150 4 23.7611 21.9216 5.43181 35.5612 -5.35731 -13.8865 +2151 6 52.741 18.5708 35.2268 19.1809 2.02674 5.12186 +2152 4 52.5591 18.101 34.4104 -23.468 -7.47943 -3.72799 +2153 4 51.9957 18.6447 35.8177 -20.5936 -5.49273 0.0575333 +2154 6 3.56038 27.2788 25.2921 -16.6903 -17.6792 -11.4043 +2155 4 3.96469 27.2185 26.149 7.10467 -3.13705 18.347 +2156 4 3.97939 27.9962 24.8424 10.8751 21.6711 -8.62461 +2157 6 34.4448 32.9974 30.68 48.2331 9.00339 -1.41906 +2158 4 33.5189 32.8245 30.8394 -9.09046 9.48004 8.12592 +2159 4 34.8804 33.6211 31.3233 -29.3839 -17.782 -5.29467 +2160 6 35.2611 23.7526 9.83248 5.28039 9.63542 14.9856 +2161 4 34.4624 23.9143 9.32096 3.45609 1.41047 -6.97204 +2162 4 35.624 22.9154 9.5528 3.26088 -11.8232 -8.34585 +2163 6 42.4243 15.7233 8.97763 12.8326 1.39623 12.6931 +2164 4 41.658 15.328 8.60072 -22.8346 -8.994 -22.1277 +2165 4 42.104 15.9534 9.85586 1.77226 3.68974 5.84069 +2166 6 7.76866 28.8533 32.9548 -11.0049 17.2013 -15.4709 +2167 4 8.04862 28.1203 33.4848 1.42969 -15.0059 16.0601 +2168 4 8.50079 29.0495 32.3677 8.58058 4.20069 -3.59376 +2169 6 17.6953 41.2515 36.4663 -11.3067 -18.3758 74.5383 +2170 4 16.8889 41.7296 36.6796 -1.19906 6.43806 -6.60961 +2171 4 17.8689 41.3412 35.574 12.2332 11.1792 -57.8962 +2172 6 28.5157 24.2416 15.5518 -29.4686 -13.3801 -11.1317 +2173 4 29.0166 24.9984 15.2559 10.2779 3.66755 -9.57255 +2174 4 28.1226 23.7858 14.7645 18.214 7.11075 11.8426 +2175 6 20.955 16.2999 1.15679 52.4547 14.172 -5.31351 +2176 4 20.9215 15.3848 1.33551 1.21723 -32.5558 11.4722 +2177 4 20.0795 16.5686 1.08505 -57.8144 13.7968 -3.85053 +2178 6 31.1684 40.7359 5.3086 9.60886 -48.7905 -14.3252 +2179 4 30.3201 40.4364 4.96776 -1.1434 5.1051 1.34806 +2180 4 31.1111 41.6485 5.46945 -11.8258 44.905 11.395 +2181 6 29.926 24.7744 36.4585 -3.76808 18.8348 4.26027 +2182 4 30.4252 25.4661 35.9713 -7.21832 -13.6313 5.02454 +2183 4 29.9738 23.9763 35.9568 8.68635 -20.1437 -13.5665 +2184 6 8.66863 31.0429 3.90108 5.49181 -25.3701 -11.391 +2185 4 7.74616 30.7992 3.95988 -7.56137 -0.630176 -1.16432 +2186 4 8.75287 31.8877 4.30735 2.25384 31.6916 10.4967 +2187 6 5.52708 32.7014 11.4113 -17.1068 -29.6258 4.38787 +2188 4 4.72561 33.1583 11.715 12.8879 6.23598 -5.09299 +2189 4 5.16474 31.7796 11.3163 19.6841 23.1791 1.24929 +2190 6 45.6525 35.4522 20.4433 4.50188 -15.2767 -13.8779 +2191 4 45.1533 35.403 19.6071 0.884587 3.9764 11.125 +2192 4 46.1815 34.6145 20.4501 -8.61117 18.3435 2.22997 +2193 6 19.5135 2.78077 9.78076 -23.679 -24.2198 -16.6656 +2194 4 19.3296 3.70289 9.60293 -7.62346 7.89228 3.64078 +2195 4 18.7563 2.26696 9.35595 24.4568 20.2801 14.4664 +2196 6 54.9521 9.08257 10.915 1.41457 -13.8994 3.08946 +2197 4 54.8451 8.89609 11.8656 1.69601 3.75098 -5.72792 +2198 4 0.659909 9.73404 10.7859 1.63405 2.05096 5.26063 +2199 6 21.028 26.5613 14.7909 22.3934 -16.1712 -61.6784 +2200 4 21.2545 26.1082 13.8887 -5.63248 33.4215 43.8962 +2201 4 20.0757 26.5096 14.8457 -4.66041 -4.09977 8.40724 +2202 6 14.1565 30.5187 27.5481 43.0568 3.88252 13.2649 +2203 4 14.5478 30.2647 28.4319 -11.7888 3.54471 -30.6513 +2204 4 14.9443 30.8429 27.0102 -33.9181 -6.53128 14.6047 +2205 6 29.8147 17.3367 31.0866 -27.8518 -4.92818 12.2149 +2206 4 30.6554 17.4646 30.6741 20.9401 8.7355 -10.9161 +2207 4 29.248 18.1063 30.9142 12.1966 -0.59561 3.44929 +2208 6 50.8794 17.2985 27.8251 -38.7154 2.44379 -6.74856 +2209 4 49.927 17.6315 27.8951 41.9068 -8.6615 -2.42711 +2210 4 51.4551 17.8493 28.3603 -3.47276 2.02156 5.1771 +2211 6 46.2645 37.0852 13.9854 4.42941 -15.3994 -45.1385 +2212 4 46.1048 37.4162 14.8449 -7.65894 23.339 32.9902 +2213 4 45.682 37.569 13.3645 -0.578519 -6.08013 10.2779 +2214 6 38.1859 37.2676 33.1408 3.52211 -11.0724 24.5555 +2215 4 38.5393 37.4103 34.0404 -6.68303 -10.0954 -6.88307 +2216 4 38.6219 37.9461 32.6369 2.42637 17.4604 -15.0111 +2217 6 41.8357 13.3473 31.1178 -16.0625 23.8584 17.742 +2218 4 41.5851 13.9423 31.8754 7.82637 -22.3228 -20.2899 +2219 4 42.4009 12.6411 31.4368 6.59024 -10.1979 3.85371 +2220 6 46.9027 12.6459 17.8387 -27.1897 30.7666 -32.0186 +2221 4 46.619 13.5972 17.8049 11.7948 -22.8605 3.48595 +2222 4 46.5208 12.2901 16.9886 18.0608 -3.03081 22.7278 +2223 6 32.0582 10.0955 10.6527 -31.4378 50.3229 23.4622 +2224 4 31.7762 9.76632 11.5317 8.81554 -8.40176 -19.9459 +2225 4 31.6698 11.0464 10.7004 29.7372 -48.0302 -12.3835 +2226 6 34.0062 11.3773 6.75186 17.7871 30.589 25.6979 +2227 4 33.4869 10.5999 6.69262 -19.6684 -30.9606 -3.70709 +2228 4 33.8274 11.7035 7.66069 0.227829 -0.558148 -16.2574 +2229 6 45.3288 30.8634 19.4834 2.25993 -0.395596 -7.26595 +2230 4 45.2654 30.706 20.4282 2.85912 -9.1252 8.63447 +2231 4 45.808 30.1003 19.1195 -1.86475 4.39364 7.74954 +2232 6 20.3535 0.575918 7.15275 2.53913 19.7072 2.1264 +2233 4 20.3036 0.62077 8.11765 -6.02971 -5.31178 -3.74759 +2234 4 20.3373 41.5708 6.90351 -3.42232 -20.4047 0.354773 +2235 6 15.9901 39.4523 4.14302 -22.6863 14.3541 -4.96379 +2236 4 15.4898 39.956 3.48033 13.9059 -6.08345 -3.0001 +2237 4 15.6535 39.8695 4.95456 5.06581 -11.7067 3.21286 +2238 6 52.4222 16.4823 25.1021 7.38571 -14.026 0.748627 +2239 4 51.9391 16.8928 25.8315 -3.23714 5.96419 -6.435 +2240 4 52.4547 17.0876 24.3371 -9.72126 -3.91711 12.1205 +2241 6 38.5305 12.9945 3.24722 36.6577 77.8042 9.91619 +2242 4 38.7269 13.7231 3.96388 -16.2716 -45.5952 -32.5571 +2243 4 38.0745 12.2732 3.61889 -23.0516 -27.5087 18.4748 +2244 6 35.1404 29.6968 31.1683 -32.7778 -10.63 75.6098 +2245 4 35.326 30.1595 30.3922 19.5999 28.8984 -42.5223 +2246 4 34.769 30.3505 31.8393 8.36493 -22.8372 -28.4638 +2247 6 9.52941 33.7628 4.86075 -28.4918 10.8311 18.4951 +2248 4 9.24769 34.3211 5.62607 6.24621 -9.23174 -22.6788 +2249 4 10.3628 33.3905 5.10095 17.2263 -8.07265 -0.549435 +2250 6 21.5384 22.0668 20.5377 -8.24916 -13.7408 18.0665 +2251 4 20.8389 22.6833 20.2982 1.69112 5.82217 1.92954 +2252 4 21.3229 21.7148 21.445 5.44386 11.4228 -26.5573 +2253 6 37.5752 11.1922 41.2961 -25.7405 -15.8592 15.4541 +2254 4 38.0284 11.8044 40.7564 10.4246 30.4728 -30.151 +2255 4 38.2644 10.586 41.5433 15.0535 -11.8566 15.4014 +2256 6 33.8981 1.42806 38.7459 -9.94409 -6.93964 -8.18458 +2257 4 33.592 0.608166 38.3248 2.39341 2.703 9.2739 +2258 4 33.9534 1.28552 39.7002 -3.4763 3.29487 -4.45631 +2259 6 4.57081 26.6822 28.0049 6.08842 -57.033 -35.5124 +2260 4 5.0914 25.8197 28.0746 -15.9746 40.4578 4.78317 +2261 4 4.85783 27.3427 28.6052 16.6445 16.915 24.1865 +2262 6 10.2586 0.903759 11.6235 -14.777 -30.5961 35.2813 +2263 4 10.598 1.12099 12.5147 -1.53351 -1.03605 -18.7158 +2264 4 10.5217 1.55247 11.0069 12.731 34.1315 -22.4253 +2265 6 17.6428 19.8087 2.34625 28.3489 11.7442 10.4095 +2266 4 17.8694 20.4455 1.65312 -0.920106 -2.92675 2.15413 +2267 4 18.5186 19.4679 2.66241 -18.7748 -2.39069 -7.57655 +2268 6 32.4269 25.6656 16.4745 -22.7384 46.4686 12.005 +2269 4 32.9526 26.0936 17.1754 -0.693509 -13.2017 -11.5041 +2270 4 32.8268 24.9018 16.1119 18.5502 -33.1172 -3.66835 +2271 6 33.2526 10.6326 0.323883 9.44704 -29.8166 -9.67306 +2272 4 32.8511 9.97264 41.5994 12.5609 21.6724 15.7642 +2273 4 34.1113 10.2426 0.662313 -26.6835 12.0422 -7.05376 +2274 6 4.94395 4.51414 10.1428 13.8645 5.4827 29.102 +2275 4 4.09398 4.95549 10.181 -4.94694 -3.34603 -2.54834 +2276 4 5.29018 4.56097 11.0773 -8.61071 -3.77852 -28.7481 +2277 6 27.0981 16.9726 9.55361 -31.982 10.5528 -14.2027 +2278 4 27.1645 17.5497 10.32 4.78099 0.707575 6.97209 +2279 4 26.2221 17.2303 9.15822 25.9284 -7.90001 11.4222 +2280 6 9.97547 10.5192 19.3751 2.18725 8.20489 55.882 +2281 4 10.4385 9.92127 18.8097 14.3325 -20.7925 -15.5795 +2282 4 10.1136 10.195 20.3283 -2.00877 10.2565 -41.5362 +2283 6 19.5726 8.5313 27.8509 32.1681 -5.32712 19.6321 +2284 4 20.0623 8.73326 28.6965 -13.9453 -3.32017 -28.6613 +2285 4 20.1531 7.88958 27.3718 -16.7413 15.1406 10.2365 +2286 6 47.0715 38.9553 23.1297 -19.9487 1.16408 5.20576 +2287 4 47.6755 38.9992 22.3956 6.55525 -5.77104 -8.99339 +2288 4 46.1921 38.7934 22.7438 5.29072 4.97192 1.21114 +2289 6 19.6864 25.3648 11.2698 -35.9279 -4.62509 3.50742 +2290 4 18.9891 24.6498 11.3772 26.0807 25.4649 -7.71219 +2291 4 19.2193 26.1995 11.535 7.74761 -20.7647 -6.77192 +2292 6 27.3916 13.4622 15.7395 34.9583 -25.2468 -27.4167 +2293 4 26.6227 13.8144 16.1317 -23.8298 14.7279 29.1585 +2294 4 28.0863 13.1847 16.3728 -7.05347 8.15442 -0.924368 +2295 6 18.6718 14.1326 1.43279 -0.407031 -28.5308 -28.57 +2296 4 18.3771 15.0354 1.29678 -0.169849 11.7565 -8.38297 +2297 4 19.1904 13.8513 0.615983 -22.2167 19.1803 27.2908 +2298 6 42.3082 22.0346 32.4819 -45.1257 5.10199 -13.868 +2299 4 42.1064 21.5657 33.301 1.02444 -1.81924 7.74271 +2300 4 41.4227 22.4584 32.2639 35.231 -14.359 4.36271 +2301 6 10.0299 9.44853 2.50633 35.8335 -20.1603 -5.5533 +2302 4 9.22808 9.80314 2.87263 -22.9312 8.40439 12.9687 +2303 4 10.3707 8.71125 3.07205 -18.436 14.324 -8.13067 +2304 6 6.82989 1.45163 22.0085 -48.1074 -31.7833 -34.6048 +2305 4 5.93364 1.52189 21.5813 27.761 13.2569 19.2226 +2306 4 6.99793 0.508973 21.801 12.0554 14.7409 9.93393 +2307 6 11.2802 27.0298 18.9733 1.62982 48.8223 -5.8971 +2308 4 11.8533 27.1031 19.7597 -5.53045 -6.49976 -4.21856 +2309 4 11.2066 27.9871 18.6476 2.337 -33.8373 14.078 +2310 6 41.4807 20.5084 27.2133 -10.1157 30.3313 5.28758 +2311 4 41.6238 21.1535 27.9303 0.1153 -0.646751 -15.7402 +2312 4 41.3475 19.7242 27.7174 2.20222 -28.2193 4.24429 +2313 6 15.4457 24.115 33.4309 -8.0908 -15.9975 4.96928 +2314 4 14.6694 24.1264 34.0087 5.2648 16.329 -3.20307 +2315 4 15.6051 23.1634 33.3621 10.6851 2.75783 3.25666 +2316 6 36.1374 16.3773 10.0083 -2.95201 1.72364 21.0093 +2317 4 36.0354 15.4723 9.6971 0.275369 -1.57281 -6.84486 +2318 4 36.1532 16.3058 10.9756 2.3103 1.89663 -9.38056 +2319 6 51.7249 16.2592 2.09899 -0.8354 -35.479 4.00209 +2320 4 51.3025 16.6477 2.84061 -15.4293 29.383 24.1936 +2321 4 51.7588 15.3279 2.40044 5.70816 13.7616 -13.313 +2322 6 23.409 8.55726 39.7719 39.5062 -11.15 -25.6965 +2323 4 23.7264 8.82822 38.8637 -18.295 -2.70527 32.3134 +2324 4 24.154 8.00621 40.1033 -17.8621 14.2471 -2.43096 +2325 6 36.7611 34.4487 21.1056 -9.59584 -7.71653 -9.58874 +2326 4 37.1943 34.5847 20.2534 -2.45984 1.11901 0.357954 +2327 4 35.8017 34.351 20.9183 13.0848 5.20904 4.89404 +2328 6 14.146 8.88688 27.2949 11.3522 43.6232 -16.453 +2329 4 13.5534 8.17113 27.3093 -27.716 -37.4722 8.68734 +2330 4 15.0033 8.5993 27.5988 11.0136 -4.6565 4.44913 +2331 6 20.6652 37.4903 25.1946 -10.211 -17.9881 -36.0994 +2332 4 20.7454 36.6557 24.6643 4.11278 14.2078 23.4923 +2333 4 20.5382 38.1243 24.4693 3.50396 4.35638 18.4557 +2334 6 28.825 24.4792 30.0383 -7.87557 -12.5525 -14.3175 +2335 4 28.2203 24.3409 29.2957 -5.62902 14.2643 8.72595 +2336 4 29.6177 24.0933 29.6588 14.1928 -3.34691 9.72359 +2337 6 8.38024 12.0023 23.6849 17.6034 -17.8042 43.8798 +2338 4 9.33151 12.0391 24.0095 -25.5352 0.9508 -22.7134 +2339 4 7.93543 11.4413 24.3789 8.15752 13.9726 -18.9857 +2340 6 16.0957 26.6613 22.9482 -4.23776 -4.88874 3.00129 +2341 4 16.4041 25.8866 22.4682 2.11349 3.20317 -0.347462 +2342 4 15.2797 26.4088 23.4009 6.04671 4.79823 1.078 +2343 6 22.346 41.3881 9.48723 24.9275 -16.664 -2.62618 +2344 4 22.5706 0.299269 9.06271 5.87112 18.1013 -4.15908 +2345 4 21.5005 41.5154 9.87839 -30.5435 3.49176 4.55444 +2346 6 49.3776 19.1851 32.3736 41.1751 -38.6142 12.6649 +2347 4 49.9515 18.5305 32.8666 -19.8114 22.1793 -24.5398 +2348 4 48.9751 19.6643 33.0815 -18.7203 16.5505 12.5326 +2349 6 29.672 28.434 31.2292 -0.0990093 -59.7528 33.1636 +2350 4 30.5672 28.114 31.0525 8.33151 24.242 -15.2883 +2351 4 29.4026 27.6233 31.7702 -3.76231 36.9508 -17.5145 +2352 6 5.09757 39.1181 23.5694 28.9365 -16.8561 66.257 +2353 4 5.426 38.785 24.4883 -20.96 9.44698 -53.4069 +2354 4 5.17377 40.064 23.6953 -4.19226 13.7611 -6.16678 +2355 6 42.9396 13.594 41.6013 33.1291 -45.1938 12.1175 +2356 4 42.8466 14.3322 41.0449 -16.6361 37.6348 -21.2948 +2357 4 42.1546 13.3797 0.17078 -22.3633 5.8076 7.08965 +2358 6 21.2201 12.4318 7.37385 41.5974 -14.6934 -10.3279 +2359 4 20.2896 12.3563 7.35505 -36.2241 5.92132 -7.85999 +2360 4 21.5284 11.6004 6.96932 1.7608 11.2928 4.8084 +2361 6 43.1404 26.8989 37.6922 38.0431 -66.5876 34.8581 +2362 4 42.455 26.3454 37.3085 -15.3628 11.0452 -11.3741 +2363 4 43.7284 26.1839 38.1775 -25.099 52.0029 -25.4853 +2364 6 19.5406 10.6485 41.687 -7.00401 -34.9019 -10.1363 +2365 4 19.0738 10.6767 0.596923 -7.19888 -1.38148 21.2635 +2366 4 19.8536 11.5162 41.559 12.2515 43.5875 -9.13673 +2367 6 53.6223 10.061 3.2559 12.5469 7.56169 -12.6981 +2368 4 54.2024 10.8465 3.22155 -5.5124 -7.95383 7.8004 +2369 4 54.0687 9.40413 2.68363 -10.8512 12.6529 5.34221 +2370 6 17.5742 20.1926 28.4231 -27.2496 23.4973 23.4861 +2371 4 18.0413 19.6307 27.8376 17.787 -14.8025 -21.0857 +2372 4 18.1273 20.2938 29.2048 3.54631 -0.489564 0.0042962 +2373 6 36.884 7.32584 1.68504 -56.6071 21.2656 -14.3658 +2374 4 37.7051 7.59774 2.01592 38.2946 9.18211 20.2394 +2375 4 36.4748 8.1931 1.44071 3.42518 -20.8507 2.42249 +2376 6 29.2181 41.4159 1.83346 -7.01124 13.363 14.2223 +2377 4 28.4272 0.01466 2.15652 15.3791 -9.50345 -13.4545 +2378 4 29.1899 41.2946 0.880744 -4.61983 7.49126 -6.31737 +2379 6 13.5157 3.09172 8.12958 -12.3356 7.91728 -16.4605 +2380 4 12.824 3.78046 8.01164 12.4629 -9.10221 7.3254 +2381 4 13.8551 3.1491 9.02604 -1.1531 -1.24526 3.73064 +2382 6 15.0243 29.578 18.5071 -0.689822 5.1468 -1.91807 +2383 4 14.6889 28.924 17.8685 -1.8514 4.35612 11.642 +2384 4 14.2858 30.1508 18.7969 8.46412 -5.78667 -10.3485 +2385 6 10.5031 24.7013 24.3729 39.9308 52.3958 -21.489 +2386 4 10.8696 24.6855 23.439 -22.6214 -1.85919 30.3756 +2387 4 10.1444 23.8694 24.566 -23.1097 -44.7323 0.689524 +2388 6 2.33043 13.8499 25.1512 12.2217 -8.49201 10.1592 +2389 4 1.51988 13.5482 24.7402 -5.80441 -9.83551 -11.7005 +2390 4 2.2572 14.7938 25.1495 -10.3249 16.8303 -2.61333 +2391 6 31.8608 32.7615 29.8175 -5.917 1.92483 -13.0568 +2392 4 30.9148 32.9142 29.9093 1.86919 3.45723 4.06263 +2393 4 31.9038 31.8703 29.4643 1.33296 -6.10517 -4.90202 +2394 6 37.5413 40.8309 33.9785 -53.8639 -49.1526 -10.38 +2395 4 37.2515 40.0243 34.5353 23.0474 40.5808 -8.35317 +2396 4 36.818 40.8104 33.2846 24.4839 11.2763 19.2644 +2397 6 24.0486 38.1463 34.3459 4.38709 -25.8386 -29.9356 +2398 4 24.1932 38.0251 35.2675 1.20986 12.6476 31.9448 +2399 4 24.4562 37.3431 33.9843 -4.45208 9.66559 -5.62065 +2400 6 37.1813 22.5726 7.37313 12.7367 -26.0408 21.8779 +2401 4 37.6868 21.7363 7.50199 -14.9443 17.386 1.08188 +2402 4 37.2974 22.7741 6.46124 2.1827 3.60906 -24.8808 +2403 6 4.31908 23.2435 35.594 -25.7168 -2.52913 6.61784 +2404 4 4.31865 22.3787 35.1609 -1.33991 4.89576 -0.266123 +2405 4 3.37757 23.4898 35.7698 13.7393 -2.9658 -3.46645 +2406 6 15.7444 14.893 2.66063 14.3192 36.2435 46.5189 +2407 4 15.9445 15.8567 2.71494 4.00237 -25.0016 7.78932 +2408 4 15.3014 14.8369 1.84861 -12.1852 -13.1154 -36.1328 +2409 6 48.1607 23.1823 2.03014 17.998 -4.54201 -11.9107 +2410 4 48.5744 23.458 2.84259 8.43731 2.94545 12.5813 +2411 4 48.9225 22.9045 1.46682 -22.9697 5.41467 1.46601 +2412 6 24.1212 19.9771 21.5555 -13.5297 -6.85262 15.9953 +2413 4 24.2241 19.3198 22.2577 -12.7792 13.8262 1.69378 +2414 4 24.7627 19.6352 20.9706 23.452 2.79195 -33.2435 +2415 6 10.5793 29.3754 5.15175 -1.75103 26.9922 -14.4666 +2416 4 9.93004 29.8841 4.64694 -13.9608 -12.0643 5.47156 +2417 4 11.3599 29.8389 4.86113 16.4531 -5.21099 6.28998 +2418 6 5.96767 27.6933 31.2336 10.2296 -18.0279 -26.5205 +2419 4 6.63185 27.1353 30.7398 -17.0624 11.0978 13.8341 +2420 4 6.49058 28.2721 31.7915 6.44996 0.578865 12.7715 +2421 6 18.5397 25.8071 15.3312 30.8629 -17.2743 -78.9847 +2422 4 18.3277 25.7099 16.2038 -28.7942 6.39581 79.7195 +2423 4 17.897 26.3418 14.8644 -17.4943 11.9017 11.8989 +2424 6 52.0949 37.2335 11.1138 -0.736115 -25.1617 0.200807 +2425 4 52.5552 36.4743 10.7101 2.49656 11.0988 9.7325 +2426 4 52.7586 37.8745 11.3958 -2.29245 7.10647 -7.85035 +2427 6 46.8562 14.6296 7.3094 -39.0502 -6.9365 63.794 +2428 4 46.1382 15.0906 7.8718 34.2719 -4.68193 -40.7336 +2429 4 47.0431 13.9061 7.9424 14.2062 7.46383 -20.3992 +2430 6 22.2508 0.698906 41.6783 16.129 -5.34947 -25.8041 +2431 4 22.2008 1.66415 41.7125 4.72421 -6.65403 -6.59212 +2432 4 22.9559 0.389699 41.0229 -20.0941 20.4891 31.5318 +2433 6 4.05761 14.7345 9.27152 -10.7438 13.6286 -6.0443 +2434 4 3.56043 15.5915 9.15395 12.8436 -23.8424 -1.56379 +2435 4 4.93811 14.8828 8.92118 3.87558 5.66633 -1.10852 +2436 6 37.2917 12.6666 37.0157 -30.741 -16.0859 47.3668 +2437 4 37.7371 12.676 37.8973 0.89189 9.6387 -16.8975 +2438 4 36.3707 12.3712 37.2872 32.4569 8.65188 -22.8431 +2439 6 26.6682 29.0903 40.5985 -18.9168 16.4285 3.4146 +2440 4 27.032 28.2632 40.812 19.8197 -36.7417 16.2821 +2441 4 26.6469 29.0593 39.6552 2.37875 14.8387 -20.8034 +2442 6 7.22455 13.851 3.31845 32.6668 -55.3021 -17.7697 +2443 4 8.0198 14.2759 3.60088 8.05656 35.1068 9.02454 +2444 4 7.66854 12.9807 3.04146 -45.3946 28.1811 11.8363 +2445 6 8.95271 34.8627 28.8342 33.802 -52.1542 -15.9648 +2446 4 9.89817 35.0055 28.6074 -18.5208 0.484683 7.95646 +2447 4 8.56267 35.6958 28.9173 -17.8026 46.8286 13.0667 +2448 6 37.1756 40.0691 40.1061 46.0034 7.56439 6.60252 +2449 4 36.245 40.1688 40.0074 -20.2243 -4.13511 -1.70673 +2450 4 37.2907 39.5142 40.8911 -6.64471 -1.97244 -3.69085 +2451 6 30.3689 6.165 27.2364 16.9392 12.8422 63.3115 +2452 4 30.1126 5.75506 28.1249 0.00544273 9.78172 -37.0876 +2453 4 31.0397 6.83064 27.5702 -18.6179 -11.6186 -23.6342 +2454 6 10.4791 22.885 18.2972 2.22892 -25.7937 -34.5052 +2455 4 11.3494 23.0331 18.653 10.7715 4.73748 7.10061 +2456 4 10.6446 22.3032 17.5049 -10.188 21.0769 23.5682 +2457 6 35.8886 14.2524 40.1239 38.6938 29.9036 -1.43051 +2458 4 35.4161 14.6576 39.3846 -1.71718 -13.5804 13.4977 +2459 4 35.4021 13.6019 40.5864 -31.0402 -18.1501 6.5583 +2460 6 6.71723 1.08854 17.7001 -3.83901 -60.8198 25.71 +2461 4 6.23156 1.19942 18.5167 -3.21909 18.7445 0.671973 +2462 4 6.88149 0.099135 17.7878 0.895752 34.2898 -15.7018 +2463 6 41.3468 34.0461 33.1794 10.5682 19.0983 -18.7578 +2464 4 40.4721 34.2712 32.8864 -29.2649 -1.70533 3.43004 +2465 4 41.8357 34.5632 32.5195 11.425 -3.18121 9.05585 +2466 6 37.2595 0.990816 41.287 9.45411 17.3584 -9.40071 +2467 4 37.687 0.20533 40.9743 -1.4253 -22.058 -8.3634 +2468 4 37.4586 1.01742 0.30817 4.28067 1.92511 18.4856 +2469 6 25.2602 30.9527 6.20609 -41.9214 10.7977 -12.9978 +2470 4 25.877 31.4326 5.6764 28.9604 0.775163 -4.96937 +2471 4 24.4759 30.9469 5.60333 12.4846 -9.23957 25.2824 +2472 6 14.2056 24.502 28.3086 -25.5247 14.5131 -24.5719 +2473 4 14.1882 23.6623 28.7056 13.4522 -31.4953 30.087 +2474 4 13.7133 24.2842 27.5041 7.94148 19.2098 -3.82225 +2475 6 34.2051 26.2238 36.0112 -48.9031 41.3361 24.9979 +2476 4 35.1144 26.3624 36.1822 32.7561 -2.50775 4.45543 +2477 4 33.7446 26.9807 36.5344 19.2218 -36.9328 -23.3608 +2478 6 32.3568 8.33098 28 25.7802 40.2385 3.20277 +2479 4 32.7565 9.24505 28.063 -37.9579 -17.4528 3.85033 +2480 4 33.1461 7.94224 27.6538 8.5967 -27.8742 -9.28785 +2481 6 11.7867 0.286536 26.9724 -1.3913 -35.2382 4.72224 +2482 4 11.7865 41.2385 26.6946 0.846362 23.7064 4.93964 +2483 4 11.6054 0.272418 27.9282 2.03777 4.09428 -12.4872 +2484 6 1.68124 0.254113 10.3309 8.7986 -13.2184 -15.0921 +2485 4 1.59717 41.2916 10.7333 -0.0350141 -2.89412 -0.990995 +2486 4 1.41389 0.849687 11.0071 -7.7361 15.4014 20.6266 +2487 6 6.75173 13.8377 8.23874 -3.6693 30.6435 -30.4665 +2488 4 6.43924 13.9799 7.29904 9.51956 -14.6006 30.1073 +2489 4 7.1653 14.6974 8.43116 5.95594 -9.45057 4.81521 +2490 6 22.2348 20.5564 6.16471 -24.0844 -9.72934 13.195 +2491 4 21.6727 21.3518 6.25881 9.87637 -7.56006 0.262552 +2492 4 21.7029 19.8181 6.55593 11.5262 14.9976 -6.6436 +2493 6 17.385 20.4497 10.8769 -35.9329 27.9153 -37.8305 +2494 4 16.5515 20.156 10.4074 25.3596 -4.97581 21.0147 +2495 4 17.441 21.3848 10.5386 11.6957 -25.2138 21.3318 +2496 6 17.7006 4.52737 19.573 -11.3777 -34.9061 -6.08889 +2497 4 17.032 4.43128 20.2569 -5.49224 11.1956 3.68583 +2498 4 17.4813 3.72403 19.0236 15.4315 33.5846 4.92098 +2499 6 0.483339 18.1114 40.0861 11.4726 -7.5634 -25.4826 +2500 4 0.218803 18.6551 40.8031 -6.40406 19.3 17.6992 +2501 4 1.29471 18.4968 39.6981 -7.50073 -9.94226 4.45973 +2502 6 22.9439 24.8131 27.8304 -1.07592 37.7895 -56.3844 +2503 4 22.8309 25.5845 27.1671 -0.125595 -37.7338 24.1587 +2504 4 22.7938 25.2149 28.6606 -3.1997 14.6603 34.334 +2505 6 42.7926 39.1547 26.7662 4.75434 20.2168 6.00074 +2506 4 43.0175 38.5002 26.1242 -2.01943 -24.6309 -11.9253 +2507 4 43.3024 39.9142 26.4608 -1.73796 0.515913 11.2644 +2508 6 26.2338 3.05974 21.8008 -0.713756 21.3652 -6.58596 +2509 4 25.6341 3.75271 22.1513 17.432 -13.3686 -8.49125 +2510 4 26.841 3.50549 21.1637 -15.4189 -7.95734 10.2455 +2511 6 54.5913 9.88629 29.5891 14.6194 -0.200122 15.6168 +2512 4 54.0185 9.11016 29.6389 -2.18077 1.53735 0.0476299 +2513 4 54.8498 10.0557 30.5251 -12.748 -2.88746 -21.9109 +2514 6 24.7662 33.7505 20.5324 -4.4887 -11.5901 7.32024 +2515 4 24.6764 34.6709 20.8407 -1.82029 -5.26135 -2.53883 +2516 4 23.9322 33.4503 20.1388 -0.463927 12.2923 -3.35723 +2517 6 41.7034 16.3049 0.90063 -4.83399 22.4927 -47.1255 +2518 4 41.2734 15.9533 1.64089 -16.394 -13.425 40.883 +2519 4 42.6233 16.3659 1.12415 18.2298 -9.67465 4.77205 +2520 6 23.3998 27.9207 27.4832 -10.7606 37.0497 -28.3533 +2521 4 22.8282 28.3407 28.1441 5.00816 -9.79407 0.156118 +2522 4 23.2556 28.495 26.6632 8.58882 -24.5485 28.392 +2523 6 32.7859 37.2984 18.7364 25.7014 -40.2058 6.96479 +2524 4 33.7401 36.9719 18.7703 -32.5146 22.7172 4.70252 +2525 4 32.7784 38.1932 18.4283 6.4981 19.1078 -10.0488 +2526 6 21.2249 27.6889 4.78917 1.7584 -25.2435 -20.8654 +2527 4 20.596 27.4146 5.46499 -5.42949 1.48454 -4.75098 +2528 4 21.0369 27.1287 3.96943 -0.427807 22.4392 26.4825 +2529 6 54.9457 17.9605 1.83049 24.1732 12.1415 15.992 +2530 4 54.6765 17.1472 1.44643 -11.2843 -21.2768 -12.0273 +2531 4 54.1938 18.5428 1.86671 -18.1074 1.0363 -7.50679 +2532 6 36.7435 10.702 6.59289 -49.1612 2.30359 2.88264 +2533 4 35.7736 10.9925 6.66913 36.3355 -9.83622 -8.29906 +2534 4 36.7226 9.77144 6.87602 6.19961 4.27664 0.325158 +2535 6 54.2959 4.49421 14.021 -47.0247 26.1641 -8.2037 +2536 4 53.712 4.99768 13.3924 28.2438 -8.88077 8.93165 +2537 4 53.834 4.66365 14.8572 10.6634 -9.95324 4.36694 +2538 6 22.1071 12.8195 32.0067 31.7906 8.9597 -11.0311 +2539 4 21.2967 13.3066 31.9589 -27.922 0.108445 -0.906739 +2540 4 22.6887 13.2954 31.3728 -6.4895 -15.5456 16.1837 +2541 6 15.3021 36.6565 4.03444 -21.8215 23.8176 13.2077 +2542 4 15.3262 37.6185 3.88215 -1.10116 -7.72226 9.53853 +2543 4 16.0423 36.3695 3.52653 17.7184 -15.2462 -10.6327 +2544 6 23.951 1.27123 5.71091 12.3119 19.4094 13.4558 +2545 4 23.1735 0.716989 5.76524 -11.3354 -5.61231 -0.786433 +2546 4 24.0519 1.77027 6.55293 -6.00641 -12.6326 -15.7345 +2547 6 14.2792 12.648 15.8066 19.0644 9.13243 11.8341 +2548 4 14.5911 12.5731 14.893 -12.6174 -10.6299 -3.28453 +2549 4 13.3818 12.3002 15.9605 12.2346 2.97194 -15.7557 +2550 6 15.0388 40.2481 6.5891 -30.9219 -16.0267 -20.9978 +2551 4 15.8926 40.3583 6.97574 17.8619 16.6743 19.574 +2552 4 14.4622 41.0349 6.73493 18.0926 -11.8876 3.06612 +2553 6 48.5605 32.6308 12.0872 21.4935 -15.1737 -19.6402 +2554 4 48.2882 31.8163 11.6222 -11.7375 10.5522 8.8403 +2555 4 49.3772 32.8772 11.5869 -20.063 0.749688 13.0696 +2556 6 11.2909 31.5377 7.21713 -14.6129 -9.26005 -15.8818 +2557 4 10.6224 30.9548 6.78826 17.7824 9.96971 10.6082 +2558 4 11.6163 32.1134 6.50388 0.884245 -9.77636 6.63484 +2559 6 30.1231 27.9968 10.2226 9.10006 8.28679 -14.6513 +2560 4 30.718 28.7273 9.95045 -8.34799 -9.59518 10.9295 +2561 4 29.9727 27.4897 9.40845 -5.6962 -0.318113 1.27302 +2562 6 27.6759 22.1164 17.3809 2.93811 -8.1883 -22.8269 +2563 4 27.2909 21.5233 16.7142 1.55949 -2.9899 10.1125 +2564 4 28.0309 22.8242 16.8263 2.77593 4.45495 11.6125 +2565 6 12.9654 4.59514 18.1625 -0.934721 -11.3223 -0.518608 +2566 4 13.4589 3.798 18.4727 -12.2499 12.1104 -13.3514 +2567 4 12.4628 4.36939 17.3497 12.7979 1.84773 4.27522 +2568 6 19.7203 6.71654 19.0744 25.855 21.5282 16.2244 +2569 4 18.977 6.16103 19.2554 -18.9537 -21.446 -0.739234 +2570 4 20.1996 6.78409 19.9214 -9.72031 -0.922856 -11.6068 +2571 6 37.1527 31.3787 11.4669 20.5156 -3.08539 55.9419 +2572 4 36.5467 31.6235 12.1801 -19.4555 -0.126446 -17.2692 +2573 4 37.8531 31.0173 12.0578 -6.7166 -8.42047 -30.0342 +2574 6 3.11862 16.2015 27.3491 -14.8948 -19.7352 -9.46107 +2575 4 2.52427 15.4561 27.6487 20.3886 21.5408 -12.2486 +2576 4 3.15348 16.212 26.3649 -6.24389 -0.0501167 23.7097 +2577 6 15.7133 9.97724 38.3591 30.328 17.4212 13.8857 +2578 4 16.1258 10.8398 38.0549 -11.3336 -30.4403 16.2583 +2579 4 16.257 9.66317 39.1359 -16.0932 10.0631 -23.9552 +2580 6 13.4043 14.2884 8.2363 15.0986 25.1191 -5.83206 +2581 4 13.804 15.2225 8.33958 -5.13839 -47.7054 6.28407 +2582 4 14.0947 13.5837 8.31616 -11.6402 16.8216 1.41307 +2583 6 1.71524 24.3141 36.392 36.4901 -22.2748 31.9402 +2584 4 1.86474 25.1068 36.8985 9.35176 9.25273 5.49175 +2585 4 1.1215 24.6177 35.7571 -36.8309 10.6894 -41.0698 +2586 6 11.1862 26.5319 32.9688 15.239 -24.9993 36.2438 +2587 4 10.9649 26.8002 32.096 -11.5382 16.0703 -24.8314 +2588 4 11.1647 27.266 33.6054 -7.17864 1.89937 -11.754 +2589 6 29.5773 0.765668 36.2911 32.6527 8.9619 33.1448 +2590 4 29.1495 0.596705 35.4758 -23.483 -6.97315 -25.4485 +2591 4 28.9625 1.07408 36.9696 -5.35236 0.153158 -12.2969 +2592 6 43.6099 13.1071 23.908 -7.75428 16.7256 -33.2383 +2593 4 42.8302 13.3868 24.3919 -4.08537 -1.1131 9.93358 +2594 4 43.3622 13.2586 22.9511 7.4693 -9.27191 32.0602 +2595 6 7.44309 19.7767 19.6705 17.8438 12.6527 -6.23579 +2596 4 6.73015 19.1919 19.919 -3.61392 -10.9972 -0.189724 +2597 4 7.6227 19.7194 18.722 -11.1837 -0.704544 3.42764 +2598 6 24.4259 4.29913 7.83629 -8.5248 -0.10499 -3.36953 +2599 4 24.144 5.21077 7.98541 -0.150025 -7.47068 -3.31634 +2600 4 24.9904 4.0546 8.57206 4.90899 -0.271036 -1.18338 +2601 6 51.4883 30.2308 31.1674 -14.7545 1.56633 -0.747328 +2602 4 50.5925 29.8847 31.2768 -1.35209 3.55691 8.49804 +2603 4 51.5844 30.2463 30.2146 11.2248 2.3182 -11.9335 +2604 6 0.913373 23.6795 16.8764 44.9279 -35.4578 23.1065 +2605 4 0.053834 23.3329 16.7065 -24.7033 4.18361 -15.1926 +2606 4 1.39802 22.8443 17.1197 -4.68332 28.5423 -3.90241 +2607 6 45.0884 19.3939 15.6913 9.05154 29.148 -44.7311 +2608 4 45.9115 18.9543 15.4906 10.1171 -6.0821 0.331933 +2609 4 44.8041 18.9926 16.4702 -27.3917 -26.115 43.7395 +2610 6 17.5003 8.70625 40.5861 -20.5343 49.5779 -9.15489 +2611 4 18.1762 9.35755 40.8219 0.532033 0.318295 -4.52849 +2612 4 17.8864 7.89597 40.8225 20.4785 -39.0634 11.6529 +2613 6 30.1832 27.259 27.1983 -17.9859 30.5387 -1.70378 +2614 4 31.0843 27.5469 27.0174 5.19664 -5.65516 3.8328 +2615 4 29.6652 28.1124 27.2385 17.8651 -30.9588 0.0373123 +2616 6 43.0672 26.1987 28.3737 -1.21405 11.7795 -35.2128 +2617 4 43.2187 25.7399 27.5308 2.18298 5.51683 1.33219 +2618 4 43.1307 25.5038 29.0079 -1.74848 -11.3154 21.2466 +2619 6 27.987 7.5851 3.0601 9.13665 18.2748 23.7588 +2620 4 28.1896 6.93215 2.40721 -2.30749 -24.2619 -13.6918 +2621 4 28.5512 7.39371 3.84357 -9.52219 0.418204 -9.11945 +2622 6 44.6779 7.22362 10.1855 -3.82519 12.3682 29.7072 +2623 4 44.5846 7.37997 11.1613 -8.64186 4.71212 -23.3906 +2624 4 45.2067 6.43644 10.1815 9.68596 -14.557 -3.94398 +2625 6 23.537 20.3907 32.2607 -4.33975 0.880185 -5.57314 +2626 4 23.324 21.1985 32.7413 -3.519 5.94106 -1.71472 +2627 4 23.9311 19.8373 32.9365 5.99895 -7.24541 1.02787 +2628 6 37.5412 21.0533 29.2807 6.26587 16.0676 16.0196 +2629 4 37.3761 20.3248 28.6837 -16.0493 -11.7352 -10.5522 +2630 4 36.7218 21.4261 29.6708 7.43039 -8.09007 -9.52559 +2631 6 49.2859 29.0787 28.7031 8.16517 -18.5587 -1.11584 +2632 4 48.658 29.8007 28.598 1.09858 8.52384 -10.5349 +2633 4 50.1522 29.3365 28.3345 -7.12297 8.09394 6.40204 +2634 6 47.5144 18.1684 15.2382 -13.098 45.3115 -50.4885 +2635 4 48.063 17.6794 15.7982 26.613 -22.2712 34.0874 +2636 4 48.011 18.9832 14.9644 -13.0138 -21.3801 10.9042 +2637 6 23.2587 11.168 16.5961 -34.2623 -16.0228 11.9175 +2638 4 23.8181 11.8474 16.2701 22.3391 18.1069 -12.9732 +2639 4 23.6107 10.3074 16.3447 5.63526 2.71733 -4.05723 +2640 6 3.14661 8.32736 23.1966 -5.33081 14.6732 5.33529 +2641 4 3.33443 7.84562 22.3891 5.23826 -4.81966 -4.36628 +2642 4 3.62138 9.17513 23.1245 -2.82501 -4.35917 1.75332 +2643 6 0.508878 16.1819 6.17622 16.4304 7.97407 55.7173 +2644 4 1.47866 16.3831 6.12713 -25.5039 -9.61354 -6.44341 +2645 4 0.329178 16.1408 7.1857 2.48639 -0.0834422 -46.7437 +2646 6 43.1796 15.6993 5.84098 -15.9449 -20.1226 -10.4934 +2647 4 42.9586 16.4507 6.36104 0.864404 19.5468 17.3894 +2648 4 44.0486 15.8407 5.47017 17.9332 8.6581 -2.45416 +2649 6 16.7038 35.4743 34.4518 -23.198 12.4372 32.502 +2650 4 15.9504 35.0582 34.0028 7.47206 -3.63127 2.95791 +2651 4 16.3197 35.7905 35.3305 20.1374 -9.24319 -26.2799 +2652 6 38.8854 7.73874 15.6833 27.6202 35.8952 13.402 +2653 4 39.2486 7.07212 15.1014 0.737034 -8.76325 -8.48971 +2654 4 39.6641 8.33099 15.9666 -32.1226 -27.7665 -11.1551 +2655 6 42.0076 36.5182 13.641 -8.45099 16.164 -4.64077 +2656 4 41.9228 35.5752 13.5656 2.538 -16.9665 4.44933 +2657 4 41.1544 36.8356 13.3036 3.7559 4.14555 2.82714 +2658 6 54.2986 15.3848 32.1119 10.5246 -16.1102 10.831 +2659 4 0.035655 15.9755 32.3754 -8.42237 -3.15332 1.00609 +2660 4 53.5781 15.9253 31.7943 -3.3302 7.96061 -4.64421 +2661 6 22.8954 13.9973 39.0304 35.7671 -1.21675 7.49641 +2662 4 23.2761 14.8055 39.421 -4.93619 -7.73369 -6.00904 +2663 4 21.9819 14.1606 38.8837 -32.0989 6.28079 -4.51925 +2664 6 48.0426 28.53 4.78367 -18.7604 -12.0579 33.007 +2665 4 48.5209 28.7824 4.01456 21.1512 11.8238 -22.7946 +2666 4 47.6247 29.3288 5.14776 5.26678 3.3179 -1.38234 +2667 6 48.833 10.6059 2.66638 -9.19187 -9.9608 -41.9733 +2668 4 48.2371 10.184 3.25557 -19.2293 -15.3999 15.8868 +2669 4 49.4018 11.1117 3.19515 27.1663 25.8201 26.2609 +2670 6 17.1043 29.3494 4.41938 0.116954 -3.05469 4.91749 +2671 4 16.3442 28.823 4.73493 -1.75912 12.177 1.49975 +2672 4 17.4207 29.929 5.14153 -0.429925 -17.6765 -0.899977 +2673 6 27.7901 7.33424 26.577 58.6208 -10.7281 -9.65958 +2674 4 28.6921 6.89516 26.6033 -20.1634 35.8081 4.28732 +2675 4 27.2961 6.54785 26.6418 -36.3357 -24.7905 3.70209 +2676 6 18.0242 22.0537 22.5144 -27.9591 -16.1551 -40.0832 +2677 4 18.4878 21.2118 22.5153 10.7066 -2.42354 6.7168 +2678 4 17.4966 21.98 21.6478 21.0889 16.8172 36.9195 +2679 6 22.144 25.0979 16.6837 -22.767 31.6961 -6.75713 +2680 4 21.8754 25.6012 15.8609 3.46788 -12.1894 37.0641 +2681 4 22.4796 24.2953 16.3382 13.1119 -24.3628 -7.92486 +2682 6 25.5147 28.4379 7.13209 -32.2353 18.5879 42.0502 +2683 4 25.3191 28.6153 8.09624 16.8162 -18.2828 -29.7283 +2684 4 25.4949 29.3399 6.82105 5.5127 9.28731 -21.7507 +2685 6 42.5447 24.7469 23.7482 -26.0567 17.8354 -0.260974 +2686 4 41.659 25.0561 24.0862 27.8337 1.55541 -7.56443 +2687 4 42.5141 23.8045 23.8516 -5.7883 -22.6777 0.706816 +2688 6 6.24511 16.6188 2.47068 -21.6781 9.7655 5.77715 +2689 4 5.36273 16.9874 2.41541 -6.24724 13.8235 -1.18511 +2690 4 6.01398 15.7093 2.58331 16.9883 -26.009 1.35247 +2691 6 47.3719 33.28 1.46148 -3.99946 1.01934 -28.2481 +2692 4 46.9803 34.1218 1.66358 -4.59906 12.9067 -8.65937 +2693 4 47.69 33.0389 2.30921 14.6803 -12.3184 23.7614 +2694 6 1.27616 36.1851 24.8829 8.16993 1.58395 -5.27854 +2695 4 0.639753 36.4584 25.5359 -13.8461 11.829 3.50901 +2696 4 1.57271 35.3754 25.2942 10.46 -9.74103 -2.86729 +2697 6 20.9413 29.0442 16.4303 -37.0385 3.95749 11.2157 +2698 4 21.4069 28.5201 15.8013 19.747 -14.8546 -14.4583 +2699 4 21.4101 29.8248 16.6953 16.4704 9.62387 -0.234111 +2700 6 18.6701 32.5426 14.1399 -11.935 -28.2137 10.094 +2701 4 17.8036 32.9051 14.2078 -15.3524 29.2867 2.90472 +2702 4 18.4356 31.618 14.3552 23.1856 4.50503 -1.59621 +2703 6 15.7338 41.7002 0.007017 -29.1796 -38.8659 -6.04008 +2704 4 15.5134 41.1073 41.1476 16.5192 17.684 16.0218 +2705 4 15.1804 41.3134 0.738607 16.9589 18.7767 -12.0866 +2706 6 20.5358 18.4015 7.20723 -36.4209 10.7746 11.3165 +2707 4 20.1727 18.4996 8.12034 18.5895 1.11111 -8.73102 +2708 4 19.7156 18.4439 6.66948 20.5956 -6.66311 2.45516 +2709 6 35.3359 2.82506 1.61733 -4.03181 47.7257 29.2165 +2710 4 34.9541 3.20961 2.47337 19.1106 -23.159 -34.5889 +2711 4 35.8528 3.61912 1.28524 -9.69035 -30.1723 1.40188 +2712 6 49.0059 19.6751 24.9502 -26.306 10.305 -4.58994 +2713 4 49.8292 19.282 24.7191 18.9727 -16.8119 -2.00329 +2714 4 49.219 20.61 24.9195 -6.54834 1.96917 8.98321 +2715 6 26.0427 7.1974 41.5664 19.1127 -25.9459 -27.3591 +2716 4 26.6886 6.46136 41.6822 -6.92827 19.3426 1.38611 +2717 4 25.5576 7.23966 0.456505 -11.7101 6.8047 33.8929 +2718 6 22.0248 3.60461 29.0185 -16.0846 7.25678 -9.40108 +2719 4 21.194 3.80897 28.5456 14.569 -4.87522 0.502932 +2720 4 22.1959 4.40114 29.525 4.81678 0.210141 7.58007 +2721 6 27.8548 32.5394 20.644 30.2008 -27.0251 30.2495 +2722 4 26.9598 32.7332 20.4747 -36.3343 12.7784 -11.814 +2723 4 28.412 33.1097 20.1287 0.615935 11.6015 -11.5439 +2724 6 8.3956 24.7909 3.45677 41.8783 30.6212 2.1827 +2725 4 8.85983 24.2427 2.83372 10.4085 -11.4169 -11.9204 +2726 4 7.65564 24.3184 3.74512 -41.6031 -24.257 6.19876 +2727 6 30.5856 41.7288 15.6573 18.8319 11.6475 40.5199 +2728 4 29.9513 0.161741 16.3149 8.82373 -8.1621 -4.69308 +2729 4 30.0935 41.6309 14.8822 -24.2072 -8.84927 -42.274 +2730 6 48.0984 5.63232 21.2085 -24.8678 -8.67647 -10.7387 +2731 4 47.6235 6.28714 20.6867 8.63769 7.09972 -0.446275 +2732 4 47.3595 5.05066 21.4474 12.3779 0.983941 9.20385 +2733 6 39.4236 23.163 35.7324 -26.6807 -22.8308 -31.4054 +2734 4 39.8477 23.6904 36.3502 31.9199 30.6139 46.0523 +2735 4 38.8623 22.5516 36.2186 -1.29306 -3.58423 7.04543 +2736 6 51.5883 33.3617 5.78995 -19.5798 -55.0773 -18.3228 +2737 4 51.7861 34.2574 5.89467 9.96767 53.6603 7.25336 +2738 4 51.5145 33.1869 4.82901 1.99858 6.27826 11.2132 +2739 6 40.1205 17.6413 30.7797 3.51386 -32.8888 9.0941 +2740 4 39.6335 18.3955 31.0853 6.47279 10.0891 -2.42254 +2741 4 40.8254 17.9321 30.1952 -5.08805 1.72673 -6.80625 +2742 6 46.4235 9.81086 18.5807 -13.6096 13.2326 25.0066 +2743 4 47.164 10.4099 18.4597 3.17276 -2.49269 -0.272695 +2744 4 46.3941 9.2422 17.832 2.02048 -17.819 -25.0993 +2745 6 15.8844 41.0843 31.9336 24.9021 -3.26155 -16.7898 +2746 4 16.5805 40.7078 31.3592 -9.31569 -10.1627 6.74042 +2747 4 16.1791 0.090931 31.8861 -11.051 9.97246 9.22539 +2748 6 48.5496 25.7276 14.9325 -23.4699 4.48431 -20.1118 +2749 4 49.4421 25.9075 14.7294 36.7388 1.67727 3.80263 +2750 4 48.1707 25.827 14.039 -11.0362 0.596064 15.3478 +2751 6 39.2225 28.9892 36.1575 1.81804 -9.3363 -11.5399 +2752 4 40.0459 29.1043 36.6225 6.32097 13.8964 11.0865 +2753 4 39.5169 28.7877 35.2623 -5.25992 -5.15898 -10.721 +2754 6 37.325 21.0738 14.9394 -7.85324 -20.9229 -64.7065 +2755 4 37.9996 20.7799 14.2865 -1.58038 10.9233 26.036 +2756 4 36.5898 21.2349 14.28 11.1979 5.88457 46.2171 +2757 6 32.4971 22.8607 15.7433 -7.91212 -33.4559 24.7905 +2758 4 31.7632 22.4534 15.25 1.55934 10.0805 -2.32687 +2759 4 32.5592 22.2921 16.5663 4.31702 21.463 -27.4441 +2760 6 18.5773 8.13014 37.5708 2.8796 34.5567 21.0854 +2761 4 19.1021 8.93687 37.8089 1.20854 -19.8484 -10.1251 +2762 4 17.9431 8.09722 38.288 -3.97249 -3.14491 3.87795 +2763 6 46.9308 30.3817 11.0144 7.20248 -9.32119 -46.6603 +2764 4 46.4987 30.7035 10.1833 6.25688 -3.94108 30.979 +2765 4 47.431 29.6318 10.6212 -6.26387 6.19468 23.2459 +2766 6 54.6355 13.051 30.6677 -0.631529 -12.3617 0.377161 +2767 4 54.9401 12.1973 31.0202 -4.70537 6.73717 3.83911 +2768 4 54.6706 13.679 31.4001 -0.542159 7.57402 -2.77471 +2769 6 32.2973 35.1412 27.9506 0.702746 7.41177 51.9011 +2770 4 32.3519 35.6753 28.7977 -4.11304 1.55554 -34.3644 +2771 4 32.0809 34.2722 28.2835 1.42742 -15.3938 2.35714 +2772 6 4.45353 25.396 31.7914 -28.2716 -32.1048 1.32297 +2773 4 5.00928 24.905 32.4172 3.79617 9.45861 3.32159 +2774 4 4.83781 26.2295 31.6234 26.2458 34.1175 0.407684 +2775 6 40.7781 38.1509 21.8521 -13.1408 -33.509 11.5706 +2776 4 40.6716 39.044 22.1698 7.33695 21.0707 -1.24628 +2777 4 41.4481 38.0623 21.1738 10.5508 14.8215 -9.14642 +2778 6 26.6931 9.85845 27.4042 -43.8759 24.145 24.882 +2779 4 26.9952 9.1619 26.8761 23.7363 -35.7414 -23.7206 +2780 4 25.7673 9.60487 27.6152 14.5566 8.07269 5.62533 +2781 6 53.3967 39.4485 11.7649 68.843 -10.0355 -14.0333 +2782 4 54.4148 39.3855 11.5456 -53.2103 8.20916 12.7106 +2783 4 53.105 40.2482 11.2866 -1.29569 -7.05369 14.3337 +2784 6 35.3292 21.4155 2.23587 15.106 -7.83484 -18.4876 +2785 4 34.912 20.5764 2.48744 -1.27765 6.93695 -0.309601 +2786 4 35.8084 21.2289 1.37944 -21.1629 3.53466 26.6292 +2787 6 4.14409 17.1449 33.9131 -16.1644 -22.9901 22.0601 +2788 4 4.14131 16.4411 34.6063 8.69636 10.7601 -14.4963 +2789 4 3.20404 17.192 33.6728 6.06844 1.20479 -9.99864 +2790 6 24.1486 16.1886 14.6752 2.90394 -28.6462 -21.9437 +2791 4 24.2343 17.059 15.0346 0.494679 15.8947 1.83084 +2792 4 23.7735 16.3203 13.7888 -2.47926 -0.947779 4.85435 +2793 6 43.1303 2.83022 26.0988 7.42094 18.4339 -15.1049 +2794 4 42.3152 3.21229 26.4285 -6.54764 -1.84254 4.96768 +2795 4 43.2129 3.23454 25.2082 4.91034 -11.1878 11.8147 +2796 6 40.68 12.1827 1.56051 12.2683 5.96873 16.2718 +2797 4 41.5968 12.2158 1.84207 12.0551 -6.37233 -9.83141 +2798 4 40.2741 12.5174 2.36876 -21.9125 -2.35909 -10.0625 +2799 6 47.3781 8.09655 26.7608 82.0606 26.064 -7.54845 +2800 4 46.666 7.67998 26.3919 -67.6244 -33.3987 -26.4118 +2801 4 48.0445 8.01522 26.0221 -12.6559 5.80771 33.8866 +2802 6 35.8947 30.7223 38.5098 17.2216 52.6179 -38.6143 +2803 4 35.6523 29.9703 39.0072 10.7188 -28.2359 27.6772 +2804 4 36.8587 31.0199 38.5623 -37.3038 -25.1724 3.03639 +2805 6 51.3054 23.2176 32.4969 -40.2617 11.1267 -4.72183 +2806 4 51.571 23.9803 31.9692 8.10126 9.10595 3.65824 +2807 4 52.0738 22.7076 32.6523 27.5758 -14.8312 4.00399 +2808 6 30.6066 4.44965 39.6625 0.615077 -4.04577 -5.4494 +2809 4 30.9728 3.64581 40.0124 3.38991 -22.1323 -0.234101 +2810 4 30.7691 5.02119 40.3987 0.467535 29.3806 6.08815 +2811 6 35.2584 29.6988 2.86074 -18.8762 -20.4699 -30.2285 +2812 4 35.7444 29.7805 2.00551 -3.31399 -2.84145 17.507 +2813 4 34.478 29.0852 2.62897 29.9452 30.586 13.9144 +2814 6 50.3064 26.1399 9.38994 -11.2342 14.6262 -3.47403 +2815 4 49.9288 26.8854 8.86032 11.0364 -25.2497 6.23881 +2816 4 49.6695 25.4035 9.37359 7.94529 9.32604 -3.86417 +2817 6 50.1026 36.8163 26.4125 -14.5138 -5.51826 -11.285 +2818 4 49.5888 36.0167 26.6617 3.79204 13.187 5.56915 +2819 4 50.2319 37.3727 27.1922 -3.20057 1.11223 6.19844 +2820 6 40.3045 23.9511 38.5442 56.3682 27.7758 -3.16545 +2821 4 40.8125 24.7624 38.7991 -6.5383 -29.3065 -12.768 +2822 4 39.4568 24.2221 38.8139 -44.6373 -1.162 12.0349 +2823 6 24.9504 10.7612 30.6561 23.3702 -4.90777 36.4738 +2824 4 25.6234 10.7245 31.4083 -25.7901 9.07318 -40.0098 +2825 4 24.9126 11.6687 30.2959 1.4184 -10.5997 2.42613 +2826 6 5.89627 1.02238 5.41014 -10.9637 -3.10309 -8.95081 +2827 4 5.14436 0.409378 5.47088 11.7326 -0.810065 6.31118 +2828 4 6.70289 0.529043 5.60145 -0.696658 -1.4992 -0.407558 +2829 6 44.282 29.3718 26.2736 69.4655 -24.0165 25.5627 +2830 4 43.5561 29.7046 25.8233 -49.9183 11.7173 -34.3685 +2831 4 44.8903 28.8623 25.6892 -19.9675 5.54095 9.74148 +2832 6 25.3119 10.1784 6.67292 -15.7736 -23.3412 -3.06725 +2833 4 25.6521 11.0537 6.64576 10.6351 24.7362 -4.37451 +2834 4 25.4625 9.79379 5.79618 6.21987 0.326131 1.26241 +2835 6 13.3514 28.0662 2.56722 45.2358 13.6418 17.9819 +2836 4 12.4545 27.8107 2.56105 -32.9681 -11.4511 -11.8173 +2837 4 13.8041 27.7134 1.79344 -6.10921 -0.687749 -0.120894 +2838 6 6.44709 40.2351 18.0254 21.2427 9.30891 -1.39987 +2839 4 6.966 39.4726 17.7533 0.137807 -7.29984 6.20872 +2840 4 5.59682 40.0602 17.6456 -22.1821 0.316247 -4.7234 +2841 6 47.7944 13.5061 2.01255 -17.6425 -30.8617 30.605 +2842 4 48.2016 12.6358 2.19438 -7.04124 7.54818 -3.24284 +2843 4 48.4122 13.9735 1.50015 28.8905 20.8749 -24.4455 +2844 6 13.5944 20.2974 2.4458 20.0315 11.2691 18.6487 +2845 4 13.7883 19.6075 3.10831 1.39134 9.87367 -8.40212 +2846 4 13.0064 19.8713 1.85297 -21.5499 -10.3053 -19.2062 +2847 6 15.2336 0.850818 36.6661 8.37652 40.6516 -23.9146 +2848 4 15.3117 1.46746 37.4264 -6.40063 -24.0213 -7.24367 +2849 4 15.3514 1.51981 35.909 -6.71396 -40.605 26.1829 +2850 6 33.5971 35.2491 15.0847 71.6425 -10.6997 11.4711 +2851 4 33.8969 35.3297 16.0058 -20.0956 -0.49545 -2.4869 +2852 4 34.508 35.0431 14.6807 -47.978 4.31732 -2.67502 +2853 6 21.7981 9.23698 0.429299 24.0185 -25.5324 29.6504 +2854 4 22.426 9.07175 41.6424 8.6426 -4.20457 -11.04 +2855 4 21.1884 9.81045 0.032847 -35.1273 25.1593 -17.3244 +2856 6 38.1453 27.4709 3.0333 47.9463 -55.6761 10.6859 +2857 4 37.7532 27.3037 2.19157 -17.0599 1.14667 -24.2168 +2858 4 37.8405 28.2288 3.44687 -27.291 50.0057 16.1216 +2859 6 38.8714 27.215 11.7709 41.141 -36.7506 -15.3879 +2860 4 38.9285 26.3434 12.2193 -14.3396 10.7389 0.963039 +2861 4 39.5886 27.0941 11.0922 -22.6073 11.6268 16.0227 +2862 6 29.8734 41.5737 28.6987 15.2279 35.2113 -10.5566 +2863 4 28.9552 41.3162 28.7047 -13.1778 -5.77603 2.88395 +2864 4 29.9141 0.263017 27.9132 -0.896253 -12.9147 16.3719 +2865 6 34.03 8.70777 38.0687 38.5763 27.6628 16.1728 +2866 4 34.8607 8.18924 38.1985 -14.88 11.0383 -8.6682 +2867 4 33.3419 8.15213 37.7593 -24.3719 -27.4308 -8.08559 +2868 6 38.8091 27.3495 30.6738 6.32435 -21.1782 -4.52762 +2869 4 38.5154 26.4386 30.4378 -1.34454 21.7952 1.35616 +2870 4 38.3686 27.5808 31.4849 -11.9448 1.82739 7.69603 +2871 6 41.6473 17.269 36.3639 7.45605 15.5752 1.52238 +2872 4 41.3137 17.162 35.483 -10.4634 0.342165 -15.0979 +2873 4 41.7169 16.3923 36.7151 5.72978 -18.5967 8.16978 +2874 6 30.7243 26.977 35.2074 -15.5404 -28.2563 -3.1326 +2875 4 31.3953 27.4345 34.7177 18.5093 15.4635 -5.31058 +2876 4 30.2206 27.5565 35.766 -0.690558 20.2492 9.56945 +2877 6 47.5414 4.09198 27.2867 -2.42911 13.6608 18.2544 +2878 4 46.636 4.37242 27.4325 -10.4037 -2.52064 9.15115 +2879 4 47.5606 3.99786 26.3497 6.55325 -3.96267 -23.0579 +2880 6 20.946 8.39203 7.27322 -27.8597 -45.7319 -0.818331 +2881 4 20.9365 8.74812 8.15774 -0.207227 20.4039 13.5637 +2882 4 21.4094 8.93893 6.67191 21.7448 31.5979 -18.7028 +2883 6 36.8544 13.691 0.855516 -6.96494 -6.58957 -4.7536 +2884 4 37.3845 13.474 1.605 15.5913 2.53244 29.7992 +2885 4 37.0002 12.9032 0.328977 -4.78774 -2.28905 -12.5933 +2886 6 28.5904 20.2994 26.4544 16.2695 -3.42806 -15.5352 +2887 4 28.4835 19.402 26.1318 -1.12761 -3.3858 2.90642 +2888 4 27.7814 20.5406 26.8733 -22.93 6.76513 15.2817 +2889 6 51.6079 16.8571 33.5121 -4.50033 -4.43314 5.93611 +2890 4 51.6159 16.0837 34.101 -3.91985 -0.958274 -7.09147 +2891 4 50.9053 16.6875 32.8669 7.1497 -2.58651 -2.16023 +2892 6 16.2715 32.0073 37.6936 -41.8913 -21.032 -18.7972 +2893 4 16.4093 31.405 38.4555 0.0363557 12.0183 -19.687 +2894 4 15.4977 31.6058 37.1477 38.3353 16.8511 22.6146 +2895 6 14.3407 25.877 13.2155 1.26588 11.3619 -17.2713 +2896 4 13.5013 26.0279 13.6901 5.40221 7.27027 -0.947788 +2897 4 14.4551 26.5608 12.5093 -9.57117 -0.277473 20.5459 +2898 6 54.9749 28.8768 3.30374 1.15612 -53.5629 -1.59986 +2899 4 54.8083 28.9028 2.3467 2.04661 0.129141 5.0455 +2900 4 0.26744 27.9124 3.48546 -12.4506 41.1861 -2.95604 +2901 6 17.22 5.15598 2.57931 -12.7888 -35.846 -9.7104 +2902 4 17.8674 4.52191 2.91459 -1.87097 -9.90488 -4.08214 +2903 4 17.421 5.9071 3.09191 1.36943 25.6696 10.0797 +2904 6 50.6995 33.0507 10.3154 6.59719 15.9916 42.5002 +2905 4 50.6222 33.8517 9.79386 -1.28667 2.08485 -11.8542 +2906 4 50.7575 32.2667 9.79209 -3.80283 -15.7636 -22.9095 +2907 6 28.8826 19.8405 32.3742 18.5732 17.2051 -15.397 +2908 4 29.8373 20.0763 32.2 -31.4986 -11.6613 7.66973 +2909 4 28.4094 20.6578 32.1253 1.55933 -8.77069 7.582 +2910 6 22.4307 12.8248 23.2991 -20.6917 10.5217 33.6658 +2911 4 22.5556 12.3422 24.1574 -2.40655 13.6672 -16.3005 +2912 4 21.7108 13.488 23.4947 18.3613 -16.8762 -11.246 +2913 6 54.7763 15.5394 8.86893 2.10476 3.1215 13.1486 +2914 4 0.465115 15.309 9.51431 10.762 -2.70861 -3.02895 +2915 4 53.9989 15.1653 9.30174 -3.31272 -0.629746 -12.248 +2916 6 10.4518 19.2967 26.1704 43.67 -11.1159 60.7251 +2917 4 11.2502 18.7163 26.2348 -22.5321 13.8961 -6.48776 +2918 4 10.166 19.2541 25.3007 -24.1973 -3.18459 -58.4054 +2919 6 38.6496 20.2998 35.2325 20.2193 -0.813999 -8.63065 +2920 4 39.5955 20.3672 34.9603 -17.6326 -1.16496 9.70871 +2921 4 38.5782 19.6093 35.9099 2.97533 6.68842 -2.65526 +2922 6 17.4906 18.0487 15.2499 -10.3405 45.0299 20.0184 +2923 4 17.3837 17.5615 14.4531 -8.22833 -15.0257 -32.2828 +2924 4 17.2318 18.9864 14.9797 13.5676 -28.3997 10.204 +2925 6 29.6331 0.960567 26.2796 -25.6031 -26.3316 -72.4206 +2926 4 29.3216 1.74647 25.7973 3.40072 6.61544 23.4347 +2927 4 29.2407 0.266373 25.6265 23.6279 16.4272 47.4057 +2928 6 30.4665 12.6849 28.2971 -10.7965 -27.9245 1.17671 +2929 4 29.8272 13.0822 27.7097 -1.40549 16.7134 -9.61387 +2930 4 30.1324 11.7665 28.3519 9.60572 9.94425 5.65357 +2931 6 36.6695 22.1225 33.3577 39.6017 -11.6369 -25.7224 +2932 4 37.5338 21.6663 33.4931 -10.4393 24.3252 -8.31461 +2933 4 36.1732 21.6976 34.0074 -34.1256 -9.27026 38.9845 +2934 6 34.8672 22.4666 14.3113 -12.0535 -16.0605 -66.2467 +2935 4 34.0349 22.4515 14.7407 -19.1997 11.5289 38.0952 +2936 4 34.5417 22.174 13.4128 25.6484 2.69091 24.3313 +2937 6 15.5262 9.60919 7.44527 49.3682 -27.3699 -19.0187 +2938 4 16.547 9.52246 7.26069 -54.7763 6.57045 5.33777 +2939 4 15.1277 8.71762 7.26288 7.76902 16.5773 17.8238 +2940 6 21.8158 28.0339 19.8054 -4.91607 2.79332 -16.2053 +2941 4 21.8614 28.4614 20.6522 -2.04715 7.82991 15.4338 +2942 4 20.8734 27.9328 19.6183 -0.9528 -10.4666 6.26348 +2943 6 34.5348 24.4247 2.43569 30.4222 -68.2311 14.7367 +2944 4 34.4753 23.4054 2.32054 1.69344 45.6403 0.121788 +2945 4 35.3397 24.4934 3.03523 -29.9154 15.8849 -16.545 +2946 6 12.599 20.9348 33.4989 -13.8827 -5.0407 19.8786 +2947 4 11.7591 20.6911 33.9854 14.8004 1.51093 -27.4282 +2948 4 12.4712 20.9089 32.5331 -6.4324 -2.96843 13.903 +2949 6 45.7737 31.1538 8.70434 -2.26925 11.3362 1.64289 +2950 4 45.9542 32.0869 8.96415 -8.39554 -11.7705 -15.6468 +2951 4 44.8313 30.9442 8.82297 5.93432 7.3758 2.64979 +2952 6 15.4817 22.5529 30.1787 5.69125 -30.6905 2.54506 +2953 4 16.2669 22.9885 30.4865 5.73919 23.8488 1.47991 +2954 4 15.7828 21.6299 30.2043 -15.5749 7.04719 -4.74998 +2955 6 39.7421 17.1743 38.4094 21.5551 17.0277 -9.47446 +2956 4 39.5031 16.7163 37.59 -3.21419 -6.16335 13.1695 +2957 4 40.5012 17.7258 38.123 -12.3818 -10.233 9.13463 +2958 6 13.9944 24.6739 0.675362 16.6213 17.4065 1.77653 +2959 4 14.3534 24.6315 1.57006 -7.52322 -5.04497 4.60086 +2960 4 14.2363 25.5684 0.403337 7.11699 -3.23043 -4.31609 +2961 6 31.5223 19.5616 3.57151 -53.5885 6.24325 20.3398 +2962 4 30.9852 19.2876 4.35912 8.49606 10.2921 -25.2864 +2963 4 32.3806 19.3906 3.88708 44.0272 -8.41539 -5.41474 +2964 6 36.1052 25.07 19.4414 -58.1964 5.4792 30.944 +2965 4 37.0178 24.9674 19.4291 53.7837 8.57858 1.17104 +2966 4 35.8724 24.6048 18.6565 -11.4284 -6.26335 -25.0938 +2967 6 51.6856 17.6883 14.8068 3.37141 18.4291 36.2611 +2968 4 51.7159 18.5692 15.274 12.631 -26.1695 -13.2311 +2969 4 51.0805 17.8845 14.1157 -15.036 4.32684 -29.7308 +2970 6 37.7054 27.4905 38.1961 21.1085 51.9404 -4.50496 +2971 4 37.7442 26.8536 37.5026 -5.7586 -24.9449 -15.2301 +2972 4 38.1753 28.2651 37.7886 -14.569 -23.1779 14.5181 +2973 6 34.7911 13.8542 30.7834 63.814 8.34946 -38.9004 +2974 4 35.1479 14.6416 31.2053 -8.52888 3.60926 11.6955 +2975 4 33.9958 13.5796 31.1473 -54.5977 -12.3598 32.1143 +2976 6 19.6332 37.3754 39.9698 -24.3625 -2.8653 -8.02349 +2977 4 20.5737 37.5051 40.1221 10.6449 -2.37562 -1.97502 +2978 4 19.476 36.9037 39.1231 9.83703 4.21653 7.37417 +2979 6 40.9393 34.0697 21.4586 2.1394 -11.0927 -27.2527 +2980 4 41.1855 34.0244 22.3739 -0.995015 -5.02364 12.6588 +2981 4 40.8269 33.1391 21.1809 -5.56645 12.5591 1.05516 +2982 6 32.9542 27.2131 26.5676 21.8236 31.3611 42.3808 +2983 4 33.7455 27.7378 26.9411 -38.3522 -19.3744 -9.62352 +2984 4 33.2804 26.8388 25.7801 14.7034 -8.88898 -37.5519 +2985 6 24.4045 18.6625 15.6046 15.6323 5.3487 0.0952382 +2986 4 23.6496 19.2317 15.7207 -14.8084 -1.4602 1.41466 +2987 4 24.5649 18.2576 16.462 -0.219489 -3.50303 9.55317 +2988 6 29.9663 1.63299 9.06934 -19.1782 58.0281 -13.4952 +2989 4 30.0652 0.728361 9.20589 6.15764 -53.3299 8.23098 +2990 4 29.142 1.69178 8.53744 13.8409 -0.846673 8.85197 +2991 6 31.4884 20.0987 7.87879 28.0207 -11.7442 -56.0977 +2992 4 31.929 19.6692 7.07379 -7.62771 20.3934 38.6055 +2993 4 30.8102 19.4535 8.0257 -16.4635 -8.90407 20.6678 +2994 6 35.0404 3.79156 33.2694 -1.07326 -4.91424 22.8916 +2995 4 34.2545 4.23611 32.9039 10.815 -2.65177 -4.17514 +2996 4 34.969 3.91026 34.2418 -2.62674 -1.77539 -18.1187 +2997 6 43.9504 7.96546 12.9857 17.1829 -21.9111 0.113786 +2998 4 43.3325 7.29581 13.3448 8.44862 12.3123 -3.96012 +2999 4 43.4563 8.73573 12.7333 -15.1408 11.4953 0.0339333 +3000 6 44.1156 32.6759 16.9403 5.31814 23.9263 4.94933 +3001 4 44.7028 33.4557 16.8081 -6.11209 -18.3833 -3.28173 +3002 4 44.1603 32.5425 17.8901 -3.26507 -3.06823 6.73624 +3003 6 40.6044 27.171 19.0399 5.35236 -7.54795 -39.8413 +3004 4 39.9756 26.4797 18.7399 3.73803 11.5815 8.49028 +3005 4 41.0398 27.5246 18.2027 -12.4172 -8.32437 32.3474 +3006 6 46.047 23.2024 29.047 17.2683 37.2743 26.3298 +3007 4 46.6657 23.8797 29.4684 -18.5589 -27.346 -17.4569 +3008 4 46.486 22.3548 28.9238 8.34839 -6.65718 2.80441 +3009 6 42.6215 30.6103 18.862 -5.01232 -15.325 -26.4249 +3010 4 43.5272 30.7476 19.0895 18.324 11.0008 12.4889 +3011 4 42.704 29.9429 18.1625 -17.0641 3.12823 2.85026 +3012 6 36.1251 10.8932 23.2678 23.6581 36.1082 4.04534 +3013 4 35.2523 11.2865 23.1129 -2.80799 -1.69562 1.02392 +3014 4 36.6983 11.6913 23.4963 -28.2294 -33.6871 -7.78786 +3015 6 13.7386 31.5223 15.7271 -4.49361 3.73805 -16.8081 +3016 4 14.6779 31.7192 15.7387 3.94655 -1.56597 5.72926 +3017 4 13.381 32.0318 14.979 -1.5565 -4.12563 8.0657 +3018 6 33.1703 41.4275 27.7797 10.5813 -15.702 68.4674 +3019 4 32.9714 0.101499 27.0951 -7.66273 31.9341 -41.1766 +3020 4 33.2579 0.043937 28.6255 4.60937 -17.5422 -27.6682 +3021 6 32.9019 22.9042 31.4856 -22.5274 37.748 -5.90861 +3022 4 32.2895 23.1741 30.7829 6.44322 -22.1433 -13.1277 +3023 4 32.7242 23.6662 32.0583 13.0029 -8.58894 11.8377 +3024 6 27.6559 16.8629 6.38841 0.759442 -6.33883 29.8789 +3025 4 27.8611 17.2083 5.54221 8.69809 17.4791 -25.8043 +3026 4 26.8031 16.4594 6.24591 -13.957 -6.38022 2.63501 +3027 6 47.2651 11.6173 26.0576 8.33461 35.0159 47.6166 +3028 4 47.0912 11.6838 27.0214 -5.10661 -22.4254 -22.6877 +3029 4 47.7461 12.4597 25.9756 -3.10554 -9.06377 -24.8427 +3030 6 27.5595 7.06242 7.64189 36.0057 -29.1625 5.70238 +3031 4 26.7484 7.49683 7.83093 -25.0876 11.7282 17.2448 +3032 4 28.0841 6.86482 8.45622 -15.7481 15.6684 -17.1357 +3033 6 39.8009 9.06823 11.973 -19.1879 4.0297 -12.8881 +3034 4 39.4826 9.27056 11.0665 6.39012 -4.37616 15.6201 +3035 4 38.9894 9.1094 12.5089 2.28999 7.64442 -1.09803 +3036 6 18.1977 33.4656 36.103 -47.2434 1.22325 7.58723 +3037 4 17.6693 33.9565 35.4324 13.0563 -6.22307 9.58411 +3038 4 17.491 33.069 36.7104 31.5801 5.82297 -20.8408 +3039 6 37.1917 26.5507 0.720984 -4.45309 15.6177 5.32368 +3040 4 37.3846 25.6567 0.44907 -1.85313 -8.64798 -1.56679 +3041 4 36.2207 26.6114 0.739208 8.96605 -1.46339 -9.13916 +3042 6 44.1887 19.6251 36.8885 40.0452 -6.58607 -3.19327 +3043 4 45.0262 19.1233 36.6753 -25.2412 9.90919 11.1214 +3044 4 44.4881 20.5478 36.9825 -7.95545 -4.32402 -1.12283 +3045 6 27.7744 6.35339 35.6933 13.1235 -8.00403 1.40836 +3046 4 27.1655 6.97567 35.3121 -8.4989 9.93248 -6.95364 +3047 4 27.2748 5.53908 35.7675 0.865215 -2.72076 5.22838 +3048 6 34.7673 16.4826 20.8897 25.0208 -26.1622 5.09639 +3049 4 35.5801 15.8751 20.9364 -40.3091 28.8833 0.638889 +3050 4 34.1629 16.1653 21.5964 8.34467 8.45669 -12.6288 +3051 6 39.0349 20.9701 40.4369 -35.0548 -83.2732 -20.3586 +3052 4 38.7355 20.0763 40.8679 21.616 52.9309 -20.1646 +3053 4 39.3277 21.5521 41.0958 10.956 28.6509 41.127 +3054 6 10.8075 27.9275 1.66251 45.0798 11.5101 -39.3642 +3055 4 10.1207 27.6506 2.20454 -46.3214 -11.9312 37.0665 +3056 4 10.864 28.8887 1.77269 -0.956148 -2.75571 -0.87801 +3057 6 47.0235 23.1304 13.2457 -34.1648 -14.46 -9.62139 +3058 4 47.6809 23.5773 12.718 7.19949 7.22116 -4.18429 +3059 4 46.2703 22.9258 12.6132 27.3011 3.73645 28.26 +3060 6 34.5862 28.4037 10.6629 -11.4192 -4.75939 1.42695 +3061 4 34.4799 27.7252 11.3319 -5.35328 -3.69815 4.40234 +3062 4 35.5403 28.4214 10.6073 9.29856 11.2923 -14.2157 +3063 6 3.3474 17.5828 14.2796 -19.4871 24.8451 -12.2706 +3064 4 3.54237 16.6973 14.5399 7.15819 -24.2504 13.4427 +3065 4 3.84281 18.1577 14.8755 9.98901 -5.90389 -1.38432 +3066 6 27.7213 11.5993 7.52196 5.39723 39.0715 -5.17771 +3067 4 27.6701 12.604 7.61024 4.43832 -37.6789 -1.1729 +3068 4 27.2296 11.2227 8.25132 -2.72363 -3.1191 8.53492 +3069 6 41.4314 28.3382 9.01837 19.0589 -0.973961 -18.7609 +3070 4 40.8555 28.7961 9.62238 -6.75468 20.1798 6.66135 +3071 4 41.7073 28.957 8.28743 -10.8025 -14.2077 17.7393 +3072 6 42.0854 4.7797 8.18851 -21.257 14.5957 -52.3899 +3073 4 42.0432 5.70949 7.81908 14.9695 -22.9802 20.9203 +3074 4 41.8649 4.22501 7.38905 12.6142 12.8494 32.4876 +3075 6 28.4682 8.6325 40.3242 -61.7219 6.47809 -5.55454 +3076 4 27.7379 8.57122 40.9835 27.869 -4.13123 -2.00049 +3077 4 27.8882 8.69791 39.5144 34.8971 -1.31486 9.68376 +3078 6 0.711352 18.2475 15.2828 -1.03732 14.0577 26.4962 +3079 4 1.6037 18.2498 14.9622 18.0256 -6.96047 -13.9963 +3080 4 0.201613 17.7329 14.6701 -10.6254 -13.4061 -11.9404 +3081 6 7.11345 16.2289 40.4432 8.45023 -35.9074 47.1296 +3082 4 7.17312 15.3057 40.7986 -0.221024 11.0765 -27.8146 +3083 4 7.22051 16.6703 41.3088 -5.23596 22.4775 -22.5048 +3084 6 41.0858 8.62552 20.9048 11.0684 -11.3616 26.0286 +3085 4 40.3918 8.42716 20.2762 -10.0062 9.73992 -12.3328 +3086 4 41.3944 9.53753 20.8124 -4.81268 6.06535 -10.7329 +3087 6 31.7073 7.42286 37.542 -14.8479 -9.90339 6.69006 +3088 4 31.4959 7.12404 36.6506 2.47263 0.526998 -6.01676 +3089 4 30.9335 7.11441 38.0458 14.4773 7.59586 -0.291785 +3090 6 40.7266 11.6476 25.425 -35.4896 13.4329 -16.1803 +3091 4 40.7395 12.5913 25.6925 9.9362 -18.5419 -7.18222 +3092 4 41.5423 11.2236 25.6435 22.7694 -4.71413 12.394 +3093 6 29.8665 30.1579 6.66307 26.6562 -4.16721 8.5177 +3094 4 30.5555 30.7343 6.31583 -2.18777 1.73834 -10.5199 +3095 4 30.3573 29.3259 6.76714 -13.2281 -1.59651 -6.45815 +3096 6 40.8439 24.5837 5.68012 15.8615 33.1962 -4.14396 +3097 4 41.3457 25.4223 5.9023 -8.27611 -29.5734 -8.52614 +3098 4 40.1119 24.5659 6.27901 -12.3156 -1.80355 11.8721 +3099 6 34.3917 9.09675 20.4219 17.6262 -1.15942 17.9162 +3100 4 33.57 9.43601 20.7884 -5.86563 4.88571 -3.34935 +3101 4 34.2167 8.80099 19.5352 -13.2656 -6.03918 -15.2606 +3102 6 18.2311 33.5548 26.5354 9.60899 -55.578 -54.4315 +3103 4 19.159 33.2107 26.4405 -23.3884 24.4218 8.45675 +3104 4 18.1621 34.044 27.3085 3.33799 34.4716 53.9641 +3105 6 28.9072 17.4193 26.7965 8.90265 -1.34032 10.3526 +3106 4 28.3267 16.8801 26.2506 -9.53448 5.67773 -5.57268 +3107 4 28.3756 17.7646 27.5432 9.63981 -8.23286 -8.72686 +3108 6 50.4255 35.5446 18.192 14.112 9.6817 -2.74072 +3109 4 50.5661 35.3326 17.2487 -8.6314 -7.47676 15.7559 +3110 4 50.5766 34.7477 18.7329 -11.9848 3.75846 -10.2286 +3111 6 2.99463 21.5653 31.4474 1.68271 -21.0005 -22.757 +3112 4 3.33698 22.262 30.8385 -11.1525 -11.1618 12.076 +3113 4 2.83901 20.7479 30.8788 5.9339 29.1288 19.4027 +3114 6 36.1811 18.7457 8.60665 26.0746 50.7707 2.54435 +3115 4 36.1969 17.9289 9.04749 -6.79937 -48.2248 12.3681 +3116 4 35.6147 18.7828 7.85483 -18.853 -7.00319 -22.0811 +3117 6 20.2934 6.48366 33.7248 -33.7925 -21.1439 9.08779 +3118 4 19.8228 6.33509 34.5702 11.9648 11.0481 1.53323 +3119 4 19.9109 5.73333 33.234 17.8653 6.32962 -8.93867 +3120 6 14.0016 30.5326 6.65439 -2.06342 0.226434 14.1624 +3121 4 14.6658 31.0189 7.18657 -8.4774 -5.82658 -13.2159 +3122 4 13.1556 30.6664 7.11082 5.19683 1.19435 -6.65694 +3123 6 36.2738 16.4523 35.7634 28.7444 28.7466 -1.25628 +3124 4 37.2529 16.3082 35.8444 -30.8138 -2.80693 3.80535 +3125 4 36.1869 17.4417 35.6433 -1.25715 -33.4762 0.326736 +3126 6 45.8255 37.6646 9.68707 16.0609 -41.2042 -13.6418 +3127 4 45.4852 38.2919 10.2717 -20.4348 34.8513 25.7777 +3128 4 46.231 37.0083 10.2774 7.06244 2.74597 -12.4723 +3129 6 47.4229 17.9968 27.6368 -1.79372 -57.0164 -4.60636 +3130 4 47.566 17.432 26.8065 -4.8869 24.4286 27.8294 +3131 4 47.3631 17.3546 28.4089 6.87022 22.2846 -25.0829 +3132 6 25.9574 18.2976 0.964228 23.0858 -4.77958 -10.3735 +3133 4 26.3734 18.9022 1.60725 -19.9671 -4.02324 -2.33442 +3134 4 24.9961 18.2982 0.948557 -9.32218 6.60301 10.8105 +3135 6 27.3657 22.4026 4.28337 1.04907 -15.9856 -17.2206 +3136 4 27.2658 23.3197 4.47064 2.83879 26.7243 10.1579 +3137 4 27.3462 22.4079 3.3181 -1.05974 -10.8362 7.50108 +3138 6 3.39902 3.84297 27.6033 -32.797 -16.937 8.3321 +3139 4 3.87422 4.64571 27.4715 26.6916 15.5682 -1.1402 +3140 4 3.96055 3.06079 27.6076 7.92228 2.5358 -5.38712 +3141 6 45.3564 27.6573 28.835 13.8657 -6.64535 19.4164 +3142 4 44.592 27.1099 28.6295 -10.1072 2.65107 -0.516215 +3143 4 45.3903 28.3299 28.161 -2.22034 5.33578 -9.67936 +3144 6 28.3928 32.384 16.2149 35.1766 -7.36337 1.61596 +3145 4 29.2284 32.2059 15.7054 -23.0821 5.0916 11.0276 +3146 4 28.7076 32.6186 17.1078 -8.03404 1.42552 -9.59962 +3147 6 9.90485 33.8293 13.0286 10.5996 -3.42126 36.647 +3148 4 9.63365 33.2371 13.7754 2.50037 15.8816 -14.8106 +3149 4 9.32864 33.6931 12.2897 -16.1444 -6.90665 -19.0975 +3150 6 38.3335 26.6343 14.9205 -0.551684 -24.4487 3.86314 +3151 4 38.658 25.7334 15.149 1.53578 20.736 -5.06851 +3152 4 37.3858 26.5974 15.0972 1.00556 4.30146 -0.183996 +3153 6 31.3571 16.3836 4.2445 -16.7299 -18.7641 16.8138 +3154 4 30.5501 15.9079 4.56795 14.9054 8.61271 -6.80276 +3155 4 31.2311 16.4593 3.29715 -1.72501 9.16645 -9.12782 +3156 6 6.17482 3.39637 6.55833 17.6941 29.4886 56.031 +3157 4 6.41103 3.08651 7.49149 -7.06328 10.7723 -41.2395 +3158 4 5.9143 2.63963 6.07247 -2.51266 -29.5732 -15.1374 +3159 6 42.5954 13 5.61529 2.6815 -10.2341 6.00586 +3160 4 42.2228 13.83 5.89445 -1.70762 9.74234 -1.3058 +3161 4 43.4476 12.9425 6.06763 3.18432 -3.38396 -9.63491 +3162 6 41.0469 31.4032 33.8032 -2.41258 31.7421 -2.74763 +3163 4 40.7074 31.3974 34.7214 7.44932 1.1292 -16.4995 +3164 4 41.1575 32.3688 33.5162 -1.31614 -41.8694 16.6901 +3165 6 52.8576 12.0626 26.2641 9.5895 -24.4248 -55.9842 +3166 4 52.4684 12.727 26.7939 -19.7064 26.0739 18.5009 +3167 4 52.6066 12.2568 25.3043 12.3637 -4.77707 33.6793 +3168 6 39.2086 4.29542 29.0724 8.4008 5.1904 -7.5125 +3169 4 38.4444 4.85752 29.2861 11.0986 -5.7068 1.32154 +3170 4 39.9986 4.64958 29.5231 -9.05665 -5.78587 -2.57989 +3171 6 3.65769 27.0104 11.285 -33.2394 -3.70913 -3.8751 +3172 4 4.59992 26.8829 11.3514 17.6792 2.33561 -5.11125 +3173 4 3.4519 27.7953 10.7423 10.2361 0.60791 3.91121 +3174 6 41.5441 29.6402 25.2654 2.79284 -4.6021 22.0238 +3175 4 41.8464 29.7038 24.3667 4.04268 2.71218 -16.2057 +3176 4 40.7127 30.1073 25.3399 -6.11251 5.69311 -9.79107 +3177 6 50.4754 27.4974 30.671 -6.87832 -12.1873 7.27551 +3178 4 50.0778 27.1279 31.4799 3.22248 2.82006 -4.01445 +3179 4 49.7824 27.9982 30.2275 0.0461655 4.73 -3.38362 +3180 6 32.7876 33.6322 41.7537 -8.7541 -8.89692 -39.0089 +3181 4 33.1671 32.7559 41.8028 5.47994 -11.5785 5.15438 +3182 4 32.9083 34.029 0.675063 4.83491 15.974 33.6037 +3183 6 5.9806 9.64323 7.93715 4.3965 6.41539 -15.2951 +3184 4 5.77829 9.93579 8.8312 0.6559 3.73469 4.68299 +3185 4 6.3228 10.4083 7.4265 1.56495 -8.59939 9.02132 +3186 6 52.7884 25.3949 27.7 -7.43266 -9.74322 -1.44878 +3187 4 52.93 26.351 27.8747 -0.851616 -24.8244 8.41831 +3188 4 52.9998 24.8518 28.4994 7.3809 16.2458 -18.9874 +3189 6 18.6796 23.2043 14.4609 8.49541 46.7244 28.1607 +3190 4 18.697 24.1166 14.872 -21.1178 -26.825 -16.729 +3191 4 19.5981 23.1771 14.2416 15.365 -21.3066 -15.3625 +3192 6 31.2857 9.07887 13.0786 26.2489 -54.2202 -11.3888 +3193 4 31.3193 8.20519 13.5416 -2.63874 16.5358 -10.154 +3194 4 30.7972 9.64602 13.6278 -24.9284 29.9413 31.6235 +3195 6 52.8163 16.833 29.9704 25.4684 -2.46115 -18.7711 +3196 4 53.1785 16.3479 29.2052 -11.8989 0.938692 6.7974 +3197 4 53.5445 17.4528 30.1342 -3.36222 3.81908 9.3955 +3198 6 13.4835 30.6533 11.9137 -46.9609 -12.8402 15.0292 +3199 4 12.8701 31.2475 12.4314 22.3442 -12.341 -15.3642 +3200 4 14.3315 31.0589 11.9363 20.4041 22.2607 2.0467 +3201 6 24.4145 24.6647 11.1793 -22.2983 -41.6602 -10.5575 +3202 4 25.2113 25.1208 11.3859 27.2622 9.38308 11.5927 +3203 4 24.6402 23.6908 11.0915 -11.4513 27.6962 10.6476 +3204 6 11.1203 26.798 5.92715 -0.288466 28.8994 -0.991584 +3205 4 11.4516 26.991 6.8143 4.21529 -7.59652 -0.673238 +3206 4 11.0194 27.7223 5.58288 -7.6649 -30.4822 0.0195949 +3207 6 12.0071 32.3096 4.57291 -4.86243 14.2275 -68.6847 +3208 4 11.7793 31.9281 3.63093 8.01684 14.4954 56.5286 +3209 4 12.2995 33.2463 4.37904 -4.11207 -26.5611 6.70158 +3210 6 6.4322 5.49281 30.4716 35.2368 -18.2726 5.22228 +3211 4 6.85856 6.3256 30.2181 -6.14256 4.86399 -3.96588 +3212 4 5.49729 5.53619 30.4137 -26.8093 16.306 -3.74387 +3213 6 38.1866 39.6 29.3849 -55.2477 -18.0227 -31.7741 +3214 4 37.4363 40.1798 29.0864 28.3626 1.3397 12.8196 +3215 4 37.8398 38.7214 29.0428 28.3274 26.4583 13.0641 +3216 6 52.5811 19.3636 5.41604 51.907 48.1011 -36.5249 +3217 4 52.4834 20.3242 5.17263 -20.1975 -32.0404 8.71389 +3218 4 53.4908 19.2453 4.99747 -31.6145 -20.6418 25.5541 +3219 6 18.3356 9.8205 21.0747 -17.6268 -29.6196 -17.636 +3220 4 17.8021 9.40634 20.3533 -1.88913 9.35392 27.897 +3221 4 19.0546 10.1733 20.5835 25.9839 20.5094 -7.72749 +3222 6 14.4924 41.1161 15.0432 10.1364 3.71296 -9.89663 +3223 4 15.2732 41.1462 15.6022 9.62288 -5.62086 4.10329 +3224 4 13.9031 41.7078 15.5102 -8.32301 1.75038 3.32266 +3225 6 35.9996 23.9069 26.7492 18.6837 -25.8156 -39.8793 +3226 4 35.9246 23.4421 27.5469 -8.45021 -0.659318 44.9575 +3227 4 36.3072 23.1381 26.2025 -8.08285 36.2837 5.17172 +3228 6 35.634 10.4286 26.2543 -16.0886 -36.8378 31.8954 +3229 4 36.0318 10.4196 25.4062 11.0324 6.64788 -31.8122 +3230 4 35.4344 9.46932 26.4326 4.10196 23.0818 -6.20158 +3231 6 45.3004 24.2842 20.2749 24.2383 10.4641 7.4623 +3232 4 45.3515 25.0535 19.6808 2.20237 -7.91345 -3.22769 +3233 4 44.5434 23.7522 20.0895 -20.4117 -5.11737 -13.922 +3234 6 15.8182 39.0515 24.2407 12.965 16.6456 0.954929 +3235 4 15.3741 39.8779 24.5544 7.5658 -17.411 -0.0196462 +3236 4 16.7724 39.3066 24.1247 -29.8541 -4.22386 6.92178 +3237 6 4.60659 25.9073 16.8122 1.83212 2.60998 -1.97709 +3238 4 5.31562 26.4095 17.2499 -5.00617 -6.2898 0.278133 +3239 4 3.79975 26.4302 16.9186 11.5163 2.87992 -0.585475 +3240 6 33.4767 9.9887 32.5701 -44.5277 -5.18869 -27.5725 +3241 4 34.322 10.1593 32.8843 54.6618 16.656 18.5178 +3242 4 33.0203 9.70843 33.3575 -8.70161 -12.0001 8.14623 +3243 6 22.9321 37.514 1.50284 -0.19108 -28.0604 17.8877 +3244 4 23.0149 38.2279 2.13297 1.92014 9.99004 7.14626 +3245 4 22.7552 36.7067 2.06858 1.19451 21.8657 -20.5647 +3246 6 39.1248 20.5474 25.4766 21.2332 -16.8391 26.0428 +3247 4 39.2186 21.3943 25.0643 2.22233 17.645 -5.02625 +3248 4 39.853 20.5019 26.1611 -16.83 0.667515 -19.8449 +3249 6 25.0699 25.071 37.6104 17.3941 16.9986 -26.7924 +3250 4 25.9994 25.4036 37.6322 -19.4928 -16.3283 1.07636 +3251 4 24.8822 24.8366 38.5108 -1.54859 -5.98321 18.8059 +3252 6 12.2108 35.7702 11.4211 -21.274 -0.450661 -24.3109 +3253 4 11.4942 36.1177 10.8268 17.2098 -2.57945 23.3101 +3254 4 12.7534 35.3113 10.7723 8.20233 4.40137 5.7707 +3255 6 42.0318 15.7212 20.1319 23.9789 -4.66934 -19.8056 +3256 4 42.573 15.4482 19.3354 -11.2719 11.6022 18.1956 +3257 4 42.3198 16.6222 20.3614 3.24172 -2.08619 -3.65764 +3258 6 53.203 25.4276 39.527 3.00787 -13.9161 6.63788 +3259 4 53.7641 25.8569 38.8977 9.18601 6.10619 -8.92001 +3260 4 52.4886 26.0297 39.6953 -12.4398 9.9207 3.51955 +3261 6 53.7999 21.7704 1.29423 13.4333 -6.07506 22.1965 +3262 4 54.6908 21.5389 0.969279 -9.57261 -3.1085 -1.99035 +3263 4 53.3016 22.2177 0.619486 -6.56312 6.61298 -22.2093 +3264 6 1.93757 22.4543 20.1748 -8.22485 -1.41006 19.3874 +3265 4 1.60089 23.2534 20.6505 8.04613 -19.7643 -7.74833 +3266 4 2.27012 21.8339 20.8623 2.42307 18.0741 -7.93574 +3267 6 41.1802 16.179 11.484 -8.24259 53.7733 14.6683 +3268 4 40.8475 15.3772 11.8508 -2.32532 -30.9762 7.10209 +3269 4 40.6167 16.8825 11.9353 16.6943 -22.3779 -21.294 +3270 6 17.1967 38.6113 9.60334 5.35995 -1.86267 -8.12923 +3271 4 17.7852 38.6361 10.3521 13.641 -0.452934 12.0217 +3272 4 16.3282 38.6029 9.98982 -18.6262 -0.708432 10.1602 +3273 6 33.1969 12.9538 38.5484 12.352 25.5713 -8.86638 +3274 4 33.6486 13.824 38.4674 -8.05485 -18.2555 -5.8969 +3275 4 33.0335 12.8861 39.4897 4.37007 -7.66636 -4.23751 +3276 6 24.7228 21.6957 39.9776 0.331302 -26.4697 -8.75647 +3277 4 24.5832 21.6143 39.0045 0.235774 0.581704 12.5709 +3278 4 25.2663 20.9218 40.2505 -4.0265 10.6546 -4.86064 +3279 6 13.577 15.5497 27.3411 27.7809 44.9786 27.5516 +3280 4 13.196 16.0821 28.0648 5.30872 -0.0493108 -10.0398 +3281 4 12.9031 14.935 27.2057 -29.8548 -39.4113 -11.0219 +3282 6 24.6863 18.7248 9.26482 -8.80414 -2.51529 14.0236 +3283 4 25.3563 19.2311 8.7609 -6.6335 -0.338001 12.1858 +3284 4 24.3761 19.0911 10.1338 17.243 1.91927 -22.7003 +3285 6 10.9743 8.21046 0.042398 -18.7759 13.8117 62.0104 +3286 4 10.3469 8.74796 0.639501 28.6352 -16.9877 -21.8389 +3287 4 11.7753 8.08291 0.592641 -4.28958 7.52309 -10.9298 +3288 6 15.7499 31.9609 31.3743 -17.6212 -20.5964 15.467 +3289 4 14.8817 31.9157 30.9761 -10.6343 5.00824 -7.09118 +3290 4 16.0827 32.8403 31.1978 10.1106 0.369155 -2.88897 +3291 6 20.3726 39.1695 21.6147 20.5981 -29.5513 41.0934 +3292 4 19.9726 38.3531 21.9994 -5.82675 23.323 -22.8284 +3293 4 21.1172 39.24 22.2595 -11.0324 14.4144 -20.0969 +3294 6 38.8594 19.5251 7.6091 -6.47304 13.0289 -25.1371 +3295 4 38.0017 19.0955 7.57416 -1.20877 -0.517864 1.64758 +3296 4 39.1744 19.3685 8.48411 8.18586 -10.9486 17.219 +3297 6 41.3695 29.7301 21.1465 -57.7285 -14.4296 34.1578 +3298 4 41.7832 29.6286 20.3251 24.9116 3.74799 -36.1007 +3299 4 41.9865 29.9579 21.8177 26.2541 9.18996 12.3917 +3300 6 50.7039 33.8333 22.0593 7.50244 -20.9835 17.6314 +3301 4 50.9654 32.9474 22.4123 -1.20949 24.7473 -8.4765 +3302 4 50.362 33.6446 21.1779 1.66119 1.27804 -3.63001 +3303 6 18.1671 11.1714 14.3658 -12.4278 -6.78987 13.7569 +3304 4 18.0724 11.2679 15.338 -0.312443 2.59996 -20.4321 +3305 4 19.115 11.0923 14.227 4.83391 -0.924272 -3.79066 +3306 6 48.5058 14.2689 15.2513 -36.7782 -21.7282 -18.3567 +3307 4 49.3677 14.5693 15.4148 44.1026 10.3807 8.68918 +3308 4 48.5803 13.5893 14.5426 -8.44167 10.5166 12.8885 +3309 6 32.9801 15.74 8.25484 19.5805 1.81858 6.30948 +3310 4 33.8151 15.5666 7.78828 -7.72407 0.576521 2.61047 +3311 4 33.2057 15.7253 9.21147 -5.47651 1.26655 -15.0149 +3312 6 42.9141 4.85593 18.7596 35.6338 16.8786 18.3104 +3313 4 43.0674 5.82698 18.891 -14.0493 -22.2454 -3.89051 +3314 4 43.7794 4.50634 19.0974 -23.5505 0.71427 -17.3058 +3315 6 10.488 23.7131 33.4436 27.6073 45.1219 -14.7699 +3316 4 10.638 24.6985 33.3892 -15.3766 -28.1208 6.63949 +3317 4 11.1638 23.4099 32.8243 -6.46894 -14.1785 5.09081 +3318 6 1.12582 20.0662 11.2775 2.81918 8.09367 56.8435 +3319 4 0.488344 19.3589 11.407 -2.14544 -6.99577 -20.9797 +3320 4 1.17571 20.424 12.22 2.69463 -2.11621 -44.733 +3321 6 1.50824 39.5346 14.3079 -5.25271 -28.0543 15.9462 +3322 4 0.868346 40.1487 14.6984 3.61457 -0.641003 -8.28938 +3323 4 1.2571 38.629 14.6571 12.5115 33.2201 -10.0417 +3324 6 8.3332 21.6069 14.1357 -16.8636 -16.8509 36.8071 +3325 4 8.17334 21.0976 14.9962 5.25323 23.3985 -29.627 +3326 4 7.56323 21.4407 13.5807 -3.95337 3.79773 -2.56685 +3327 6 7.16177 13.3249 38.2255 -6.34169 -18.8056 -1.32195 +3328 4 6.69256 13.0329 37.4043 9.76156 12.0715 20.3406 +3329 4 7.43529 14.2522 38.1581 -0.0118119 -11.8895 -14.491 +3330 6 46.6212 1.64167 18.6867 -0.0463537 -24.1078 41.7639 +3331 4 47.541 1.5611 18.992 -0.862753 9.16913 -10.8716 +3332 4 46.1606 1.36736 19.5239 4.43612 14.9978 -24.7224 +3333 6 4.08147 8.39338 14.788 26.1694 13.8207 2.32184 +3334 4 3.41636 8.28931 15.4347 -29.1417 0.0985708 23.0338 +3335 4 3.90156 7.69349 14.1818 -2.47935 -14.3959 -27.3016 +3336 6 47.5712 36.5372 17.8422 14.6219 44.3363 14.3039 +3337 4 47.1691 35.7037 17.6938 -6.70251 -40.3849 -9.96305 +3338 4 48.5299 36.4434 17.8412 5.708 -14.7801 -1.83759 +3339 6 48.7177 32.6293 3.61477 24.5557 -7.82504 -30.2396 +3340 4 49.3183 32.0587 3.09719 0.221751 18.4164 7.83871 +3341 4 48.4066 32.0299 4.25286 -21.3126 -17.4552 36.5328 +3342 6 26.8672 34.4113 15.184 7.18591 -12.831 -4.85448 +3343 4 27.1806 33.7337 15.7866 -5.2278 -3.11582 5.08403 +3344 4 27.3382 34.1395 14.3734 -5.71629 20.1707 6.74573 +3345 6 9.99603 27.3398 13.3337 -11.5184 -70.0362 -20.4383 +3346 4 9.96963 28.1856 12.9595 -3.0362 48.3298 -16.8459 +3347 4 9.789 26.7159 12.5598 12.8825 26.2078 29.4693 +3348 6 2.39106 26.8936 37.3456 -18.0299 -5.48602 7.48259 +3349 4 2.24944 26.7597 38.2955 12.6258 0.126767 -1.18485 +3350 4 3.33209 26.9598 37.1993 18.2818 -0.192027 1.55797 +3351 6 33.3384 17.273 36.7956 -4.69576 6.00605 30.6641 +3352 4 32.3777 17.4022 36.9421 6.35755 -1.66054 -12.3647 +3353 4 33.5147 17.1107 35.8745 -6.55426 -0.461729 -19.8283 +3354 6 10.6704 18.7989 9.29568 -2.62714 4.796 -4.28658 +3355 4 10.7729 18.8103 8.31395 -3.57004 -0.312677 18.1362 +3356 4 10.9356 19.679 9.6198 -4.15772 -1.10699 -11.1079 +3357 6 8.58029 27.4085 3.13543 -0.646896 -38.9365 14.7517 +3358 4 8.62134 27.4642 4.10772 -2.35878 18.0768 -8.00568 +3359 4 8.54298 26.4189 3.06204 -3.80038 30.3142 -4.62402 +3360 6 40.6121 33.9148 14.3433 -13.4775 28.2536 -12.7531 +3361 4 40.8898 33.2957 14.9932 8.13038 -23.145 12.8628 +3362 4 40.1237 34.5547 14.8716 -1.64981 1.12342 -7.13376 +3363 6 54.0126 16.7742 13.6402 -25.2384 12.1291 10.4483 +3364 4 54.0311 17.2666 12.8352 12.7766 5.78776 -30.0788 +3365 4 53.1083 16.9555 13.9311 3.38038 0.740926 17.4694 +3366 6 39.1613 38.4947 7.40674 -49.2832 -1.36929 38.9537 +3367 4 38.8094 38.4839 6.52049 1.87105 5.40513 -14.0728 +3368 4 38.3203 38.5292 7.99504 41.7155 2.10662 -28.5328 +3369 6 42.2152 33.6749 29.0207 -49.4578 14.7313 -27.4402 +3370 4 42.0113 34.6279 28.8262 15.7605 -21.0767 3.4048 +3371 4 41.3749 33.2313 28.6743 34.021 9.03137 24.2205 +3372 6 2.84529 0.06018 20.1342 1.75144 -0.125494 -5.27144 +3373 4 2.85876 0.453048 19.2323 -10.3946 -7.40064 8.89792 +3374 4 1.95714 41.5787 20.3005 13.5701 9.63706 -6.70109 +3375 6 24.9846 26.9367 24.435 4.97654 17.1262 30.4362 +3376 4 25.3707 26.0628 24.5275 -2.48626 -13.7157 -10.817 +3377 4 25.1946 27.3852 25.2847 -1.69157 -3.92554 -20.3381 +3378 6 13.6202 33.989 7.00835 -29.3159 10.7937 -13.6787 +3379 4 14.4707 33.6317 6.76766 5.19255 -3.31821 -12.8703 +3380 4 13.1262 34.2356 6.16936 24.7045 -4.21039 25.9053 +3381 6 17.6361 31.8361 3.38698 11.6752 63.8731 -26.646 +3382 4 17.3765 32.06 2.46015 3.81419 -8.12146 27.658 +3383 4 17.5414 30.922 3.45915 -17.4061 -53.1647 5.72422 +3384 6 31.114 29.8463 35.9142 20.4735 12.0385 -23.871 +3385 4 30.4046 29.6578 36.4892 -25.9224 -10.1565 23.4082 +3386 4 31.8798 29.3863 36.2596 4.49336 -0.641295 3.24883 +3387 6 31.4544 1.69927 1.93203 61.0942 61.1307 23.4408 +3388 4 30.847 1.03155 1.81447 -56.5376 -48.8621 -2.33617 +3389 4 31.1234 2.33851 2.60628 -4.67927 -17.7811 -18.4359 +3390 6 13.7206 9.35179 12.308 -20.4886 -14.5553 22.3614 +3391 4 13.8994 10.2254 12.0406 16.2488 33.284 -13.5816 +3392 4 13.1923 9.47724 13.1212 6.47756 -14.062 -7.29461 +3393 6 15.2915 15.1706 12.1407 -39.3514 -20.6771 -15.8676 +3394 4 14.288 15.1355 12.0691 34.6095 3.19954 13.2467 +3395 4 15.5721 14.5705 11.433 2.70369 1.94224 0.817449 +3396 6 44.9298 30.4448 13.0945 -83.0621 -13.8007 20.4391 +3397 4 45.2326 30.6692 13.9612 22.7288 5.76966 14.7184 +3398 4 45.5619 30.4921 12.4362 58.1466 4.79773 -38.6719 +3399 6 35.1494 37.6283 24.8564 -28.9971 -18.9514 34.2227 +3400 4 34.5453 38.351 25.1691 15.7809 -12.2194 -9.31628 +3401 4 34.8969 36.8477 25.46 15.2444 28.3361 -22.0595 +3402 6 43.9018 19.2999 12.9893 -4.23684 -28.8047 14.7243 +3403 4 43.7111 18.3276 12.9437 8.07938 21.0179 -2.3859 +3404 4 44.434 19.3703 13.8064 -8.2748 4.27416 -6.23054 +3405 6 14.1928 27.3824 16.8974 17.9721 24.801 -15.5057 +3406 4 13.3941 26.8971 17.049 -12.9837 -13.2841 -1.45311 +3407 4 14.075 27.8458 16.0392 0.928992 -14.2323 10.6565 +3408 6 5.07867 37.4759 15.7278 -19.2695 5.34987 61.0101 +3409 4 5.83402 37.4907 16.3496 5.41141 -1.20808 -8.02024 +3410 4 5.40595 37.3511 14.8725 27.2981 -13.142 -45.6678 +3411 6 35.4792 36.9736 33.2279 -33.1303 3.22524 14.2013 +3412 4 36.4062 37.0387 33.1707 43.394 6.70104 -6.41693 +3413 4 35.2647 37.5361 33.9926 -10.1497 -5.08286 -5.32556 +3414 6 6.63713 31.7122 32.9951 -15.6769 -13.4095 -29.903 +3415 4 7.30356 31.0631 32.7808 0.413821 -11.0386 -1.85208 +3416 4 7.01801 32.1732 33.7097 9.96672 21.2943 24.541 +3417 6 31.2686 20.2272 25.4717 1.63607 -11.2998 14.888 +3418 4 30.457 20.1188 26.0175 18.7046 8.55246 -6.40474 +3419 4 30.9671 20.3507 24.5747 -9.02709 8.2981 -6.80006 +3420 6 54.9594 26.0897 7.3541 -26.2324 -3.52234 4.1817 +3421 4 54.3149 26.536 6.76189 8.45344 -4.14623 9.81761 +3422 4 54.4064 25.6921 8.06559 9.60693 6.10548 -13.0393 +3423 6 17.8786 35.1581 24.3912 -48.4608 -31.2574 -23.2844 +3424 4 17.9034 34.576 25.1672 15.4891 12.513 -1.90366 +3425 4 17.14 34.695 23.8716 34.0055 23.8611 10.1154 +3426 6 49.1404 3.30993 19.753 -11.7437 -5.45724 -22.9314 +3427 4 48.7379 4.07245 20.162 -0.785462 12.6857 6.5087 +3428 4 49.8408 3.03849 20.3377 4.84054 -6.57183 8.59361 +3429 6 30.2791 35.6014 13.4902 -0.275976 1.62471 9.45881 +3430 4 29.4038 35.7322 13.1068 5.01216 -3.78726 -8.18413 +3431 4 30.1007 35.4484 14.4302 1.26073 -0.50544 -4.60872 +3432 6 43.3857 25.8788 41.6729 -28.3599 -13.2186 -4.43344 +3433 4 44.0236 25.6058 41.0289 13.0372 -2.28568 -15.7328 +3434 4 43.8192 26.4334 0.378509 18.4346 21.3926 23.5205 +3435 6 21.1033 23.1572 6.40534 -12.8895 6.60285 13.2505 +3436 4 21.2833 23.9599 6.94372 3.68538 -20.4677 -7.26612 +3437 4 21.2354 23.4378 5.50624 8.61756 6.39287 -19.4039 +3438 6 54.6209 21.1977 19.0953 -9.4905 16.5472 15.3455 +3439 4 0.355231 21.543 19.6762 -10.082 -5.94448 -19.8865 +3440 4 53.803 21.6498 19.4211 22.178 -8.62035 -3.94206 +3441 6 13.8696 38.9444 18.7589 -0.408574 -9.95072 10.686 +3442 4 13.5473 38.5195 19.5701 -4.79749 -3.34053 -10.6661 +3443 4 14.2783 39.7511 19.0654 -4.68159 17.5572 -2.41189 +3444 6 39.1837 2.73799 39.6933 -2.22487 -14.248 -19.2211 +3445 4 38.5048 2.18054 40.1045 3.50502 9.25929 9.72195 +3446 4 39.1752 2.3966 38.7788 -3.09486 7.3066 6.14055 +3447 6 43.2236 33.8218 8.83748 -23.7799 54.6507 -8.87946 +3448 4 43.1776 32.9835 9.22653 -2.14792 -45.6212 21.4927 +3449 4 42.4318 34.327 9.18683 27.5752 -12.6709 -4.85681 +3450 6 23.0768 16.6786 12.1043 19.2201 -8.5648 -22.0864 +3451 4 23.4688 16.2415 11.3109 -7.42341 7.06352 19.0042 +3452 4 22.1329 16.714 11.9048 -3.02708 6.60369 6.72608 +3453 6 40.7875 26.1445 36.3165 -31.0446 26.1707 15.63 +3454 4 40.1182 26.8831 36.2336 22.2291 -27.8038 4.66075 +3455 4 41.0346 25.9172 35.4285 12.0382 -0.567557 -16.236 +3456 6 15.1503 11.6728 19.298 -10.8743 -20.3409 15.6657 +3457 4 15.4707 12.2619 18.6272 13.0208 17.9076 -10.0848 +3458 4 15.518 11.9699 20.1418 -0.780585 5.28883 -4.88637 +3459 6 9.8485 29.8084 31.3808 31.6725 31.0987 -15.032 +3460 4 10.6075 30.172 31.8684 -9.75043 -12.6573 12.7307 +3461 4 9.98584 30.2945 30.5336 -20.1344 -22.7331 8.89086 +3462 6 2.12557 30.0341 25.264 -3.96851 -24.8252 -11.595 +3463 4 2.04755 29.1979 25.7442 2.8488 12.5065 4.07713 +3464 4 2.06741 29.7398 24.3306 5.27272 21.1251 20.17 +3465 6 49.0124 10.6515 7.04668 12.8278 -6.79775 19.6819 +3466 4 49.7765 10.456 7.62014 -4.12072 9.88663 -9.32692 +3467 4 48.4954 9.84699 7.16976 -12.5497 -3.43755 -7.74842 +3468 6 38.6385 34.4247 32.4851 8.7415 15.3068 2.26745 +3469 4 38.2449 35.2411 32.8392 7.79483 -2.42751 -9.0272 +3470 4 38.3877 33.7513 33.1114 -5.41613 -8.85245 5.88093 +3471 6 24.2967 24.7175 4.7858 -13.8074 20.2372 -8.25903 +3472 4 24.5879 23.8747 5.12331 8.49271 -10.4438 10.0312 +3473 4 24.0688 25.3355 5.52385 7.10746 -21.4288 -14.6014 +3474 6 44.0211 23.587 33.7713 -18.8641 -18.6234 -6.9532 +3475 4 43.6265 23.0569 33.047 -3.30007 6.44469 22.3225 +3476 4 44.7839 23.9213 33.3479 32.8249 22.1868 -7.88886 +3477 6 45.135 31.9539 26.6318 17.8742 -16.5206 -32.2352 +3478 4 44.6965 32.0125 27.458 -12.8805 4.46476 28.7394 +3479 4 45.0195 31.023 26.337 -1.34861 17.8758 10.4404 +3480 6 52.0545 6.36303 22.865 -1.87051 -30.929 -4.90791 +3481 4 51.4549 5.58836 23.0553 13.7734 29.2588 0.606927 +3482 4 51.4955 7.14596 22.8951 -3.5837 -3.73437 -5.39564 +3483 6 5.1124 17.7016 30.4663 -17.3022 -2.39818 -4.94531 +3484 4 5.57517 17.705 29.6436 5.33167 -14.42 -26.4334 +3485 4 5.6774 18.2653 30.9495 12.7188 16.8745 32.2475 +3486 6 48.5399 17.0091 6.52669 31.3107 25.6813 -22.3666 +3487 4 48.2466 16.108 6.56632 -4.44525 -18.5722 0.0807757 +3488 4 49.3123 17.0767 5.87973 -32.0368 -4.22047 21.2267 +3489 6 13.8017 31.3286 23.4652 -45.3568 -0.340859 23.461 +3490 4 14.0246 31.2001 24.3905 13.6426 -1.74144 -0.768444 +3491 4 14.5269 31.1963 22.8948 44.8358 -8.96568 -14.3918 +3492 6 28.4984 33.4231 26.025 30.2115 45.129 -4.70205 +3493 4 28.7629 32.7421 25.4284 0.749934 -18.6264 -12.7861 +3494 4 27.7356 33.1626 26.4825 -33.9251 -20.2776 22.3239 +3495 6 9.04101 22.9533 11.0101 4.17271 5.63899 8.67886 +3496 4 9.24243 22.776 10.0879 9.05926 -1.29962 -0.957415 +3497 4 9.84172 22.774 11.5341 -6.79246 0.647577 -9.3095 +3498 6 40.5624 4.0706 26.5792 43.7479 -58.1273 15.512 +3499 4 40.0377 4.03321 27.356 -14.6911 0.39925 31.4188 +3500 4 40.1771 4.74143 26.1095 -33.6389 57.2603 -43.6855 +3501 6 17.0606 37.9689 20.9328 24.9068 -2.83666 19.2437 +3502 4 17.7492 37.7057 21.5806 -0.23423 0.332892 -22.3637 +3503 4 16.3 37.9671 21.4825 -28.3901 -0.1668 6.57955 +3504 6 31.9758 6.36253 14.1925 -47.1359 -2.961 8.2158 +3505 4 31.6652 5.47044 14.4516 -0.57512 5.53961 -9.89258 +3506 4 32.9075 6.27907 14.242 33.1863 -3.34593 -3.73058 +3507 6 29.3613 34.9484 39.6522 -7.7658 6.78361 -10.4711 +3508 4 29.4154 34.7255 40.5688 2.48129 -3.65799 19.6008 +3509 4 28.4079 35.1232 39.5563 9.75382 -5.50564 -9.65046 +3510 6 22.5642 2.93231 32.1024 7.89654 -13.571 4.24933 +3511 4 23.152 3.60479 31.7467 -0.797152 8.5773 -0.128413 +3512 4 22.8746 2.10235 31.6905 -8.86372 14.3523 0.842504 +3513 6 51.7365 19.0888 24.8036 24.4352 10.6631 34.2631 +3514 4 52.2011 19.3182 25.6664 -22.8444 -5.9403 -33.5217 +3515 4 52.2256 19.5376 24.1035 -3.13425 5.18677 -1.50107 +3516 6 32.1309 13.661 24.2221 8.32979 -1.22201 -48.3483 +3517 4 32.1718 13.7834 25.1379 3.34806 7.10631 53.6256 +3518 4 31.2192 13.5434 23.9915 -25.9097 -1.66347 2.1781 +3519 6 9.49478 30.1756 28.7975 -1.02802 7.68553 8.51386 +3520 4 8.9614 29.4447 28.4635 3.13242 -3.87437 -3.11369 +3521 4 9.76139 30.7024 28.0341 -4.99689 -6.39164 -2.13333 +3522 6 31.3017 3.1328 24.0821 -2.56057 -13.3126 7.41322 +3523 4 30.8642 3.97896 23.9468 1.03353 -0.10231 -3.56587 +3524 4 32.1597 3.13825 23.6386 1.18226 10.803 -0.447916 +3525 6 2.13915 19.8328 36.4477 43.9795 26.8161 3.66972 +3526 4 3.0929 19.9274 36.115 -41.9598 -16.8793 8.64164 +3527 4 1.76662 18.9777 36.2517 -5.24508 -9.86619 -11.2286 +3528 6 36.9558 16.7701 14.0992 8.10199 -24.1685 -1.60142 +3529 4 37.0878 17.1202 14.9938 -3.44507 3.84646 -3.58016 +3530 4 37.3137 15.854 14.1066 -5.27996 15.1268 -1.92478 +3531 6 1.82451 11.1811 6.08431 4.75441 9.84221 -14.5701 +3532 4 1.68522 10.3449 6.52934 -2.64515 -5.74712 4.44833 +3533 4 1.45572 11.848 6.66197 -6.16769 2.71123 7.45582 +3534 6 43.1467 36.8536 25.2684 -4.34259 -25.2275 5.76074 +3535 4 42.489 36.6679 24.5813 -1.65581 9.08703 8.09798 +3536 4 42.9757 36.1566 25.9418 7.67001 18.3814 -10.5814 +3537 6 32.1358 5.54258 7.00813 -0.159667 5.03525 -3.02009 +3538 4 31.8447 4.70695 7.37259 1.76357 -8.94122 3.22744 +3539 4 31.6184 6.21523 7.45425 -7.92944 5.35442 3.67752 +3540 6 15.0738 21.498 41.5176 2.48253 -6.99424 4.64434 +3541 4 14.4083 21.441 0.286083 -5.89506 -4.91034 13.0846 +3542 4 14.6326 22.02 40.8608 1.523 7.8898 -22.5967 +3543 6 37.0299 36.0573 5.68999 -1.26402 -4.33671 -4.68257 +3544 4 36.8992 36.8706 5.1864 -9.04185 9.38437 4.54051 +3545 4 36.6368 36.1345 6.57983 4.68584 5.64444 -6.17041 +3546 6 39.6378 22.8733 0.344261 -10.4835 1.90991 -1.04201 +3547 4 39.8967 23.7127 41.8596 6.32696 2.65577 1.7872 +3548 4 39.7641 22.9598 1.30287 2.84221 -4.68177 2.22816 +3549 6 18.471 23.1695 5.24444 18.17 13.8994 5.32385 +3550 4 18.2426 24.0888 5.07969 -12.1406 8.45165 -11.681 +3551 4 19.3434 23.2774 5.65727 -5.17221 -14.3673 2.51868 +3552 6 34.4951 26.4012 0.415196 -24.2262 -21.8504 23.5375 +3553 4 33.9567 27.1096 0.873351 15.2264 -25.8266 -5.88921 +3554 4 34.3584 25.5285 0.919462 6.17703 40.7497 -12.3351 +3555 6 28.1538 26.089 40.6186 -44.0465 -12.7539 23.8091 +3556 4 29.0676 25.9468 40.8623 9.74545 0.451611 8.45277 +3557 4 27.5517 25.6856 41.3354 31.2048 15.0133 -28.9196 +3558 6 41.7541 4.40312 30.2348 -21.1804 7.97019 15.7848 +3559 4 42.5951 3.9554 30.1474 10.5948 -6.90465 6.49815 +3560 4 41.6197 4.66064 31.1807 9.39609 -4.15263 -13.0838 +3561 6 4.45746 8.30422 29.123 17.0584 8.0822 12.8675 +3562 4 3.72424 8.78851 28.7689 -20.5564 0.917363 -10.5697 +3563 4 4.90241 9.00738 29.631 2.39094 -12.8625 -4.67793 +3564 6 12.9051 9.61174 32.1485 9.54391 19.7002 1.20842 +3565 4 12.5238 8.90328 31.6499 -4.6135 -18.7028 0.941221 +3566 4 13.4507 9.29961 32.8815 -5.77341 -6.01915 -0.606497 +3567 6 48.6524 16.2364 1.45279 -39.5117 19.3379 22.5337 +3568 4 49.5656 16.3395 1.57323 44.82 -2.42546 -4.76282 +3569 4 48.322 16.6449 2.29127 -2.06599 -18.2277 -23.678 +3570 6 26.4391 39.9942 21.1964 -5.73 55.7886 4.05886 +3571 4 27.1886 40.6225 21.0926 -13.7426 -7.13397 8.25982 +3572 4 26.7825 39.1793 20.9147 12.833 -38.7313 -7.54244 +3573 6 35.8074 4.09236 9.03492 -45.4698 -15.3304 -15.5709 +3574 4 35.5046 4.67089 8.30824 2.24043 1.80806 6.22839 +3575 4 34.9768 3.81452 9.52186 26.5657 10.3238 -8.47709 +3576 6 52.6895 3.55751 27.8666 50.2867 -19.9176 -34.5196 +3577 4 53.5586 3.5996 28.3549 -33.5645 -3.53647 -1.9565 +3578 4 53.0019 3.22463 26.9489 -24.4009 21.759 36.9675 +3579 6 48.3192 26.6913 27.3954 13.1896 -37.7442 -6.45526 +3580 4 48.9722 25.929 27.4853 -22.116 34.446 0.770506 +3581 4 48.7243 27.4862 27.7371 6.43066 9.80699 11.7315 +3582 6 24.507 4.96042 18.7259 -17.59 -10.4057 14.9036 +3583 4 24.0519 4.20246 19.1729 14.2279 16.3534 -10.8515 +3584 4 23.9406 5.7442 18.8517 8.31711 -9.56192 -0.149656 +3585 6 24.0493 12.473 28.7688 20.4432 11.2466 2.34496 +3586 4 23.2439 12.9627 28.9427 -11.3477 -3.77152 -2.6943 +3587 4 23.8404 11.6087 28.4204 -6.74951 -3.90152 -5.01594 +3588 6 40.1637 27.7353 40.8087 -33.5791 -9.4694 0.953173 +3589 4 40.5641 26.9832 41.236 1.78301 2.25495 0.260865 +3590 4 39.2218 27.4214 40.7917 21.7476 20.7917 -9.34619 +3591 6 11.9335 13.5538 26.9488 -1.21599 4.57236 -11.9259 +3592 4 11.0364 13.8177 27.1576 -7.67129 -6.9102 2.53909 +3593 4 12.2164 12.9501 27.6309 4.70555 -13.4351 6.55277 +3594 6 52.1924 29.5424 41.3942 11.5626 -24.8936 -19.0003 +3595 4 51.8104 30.1965 0.050158 4.44506 23.3375 14.6186 +3596 4 53.1351 29.3771 41.6391 -10.5303 1.44862 4.74126 +3597 6 17.4882 19.0285 39.1853 -8.07927 32.7478 0.0743051 +3598 4 17.5012 19.6463 39.9647 -0.891206 -23.8414 -20.0908 +3599 4 17.261 19.5796 38.3923 8.05332 -16.519 21.1694 +3600 6 46.2326 27.6801 33.704 6.45393 -8.86534 7.23017 +3601 4 46.097 28.3723 33.048 -4.6559 5.79968 -1.93617 +3602 4 45.5979 27.7746 34.4233 -3.33861 16.4707 5.34235 +3603 6 35.8364 29.5448 5.62541 9.64171 -18.9009 -6.27826 +3604 4 35.5566 29.3199 4.72548 3.62776 14.0584 -3.56087 +3605 4 35.3944 30.354 5.86953 -6.57081 16.5188 2.47276 +3606 6 47.2881 25.7744 30.172 -6.62968 25.0044 -44.0548 +3607 4 48.1218 25.8653 29.6696 -5.94381 -7.49802 14.0131 +3608 4 46.6882 26.3745 29.6449 8.85802 -15.1094 17.4745 +3609 6 51.3842 12.359 20.0239 24.4626 17.3052 -5.31346 +3610 4 50.8707 12.833 19.3583 -10.0057 -7.98386 3.51527 +3611 4 50.8448 11.6564 20.3722 -11.0446 -8.70835 7.6307 +3612 6 41.976 18.3776 28.9581 25.2971 -7.26912 -18.3725 +3613 4 42.7018 17.9973 28.405 -17.3573 7.64094 3.96866 +3614 4 42.4517 18.9921 29.5246 -2.74764 -0.293653 0.793262 +3615 6 53.6043 6.48027 7.50524 -23.0657 -32.6432 -30.9738 +3616 4 53.1601 5.59498 7.33399 18.2827 28.6912 7.08019 +3617 4 53.6632 6.576 8.44633 9.6706 -3.87944 16.2616 +3618 6 9.90786 10.6094 26.7582 6.17728 8.73826 28.1859 +3619 4 10.299 10.3755 27.6331 -6.59671 -6.24018 -20.7073 +3620 4 9.65116 11.5299 26.9247 0.732239 -5.98194 -12.944 +3621 6 9.31054 39.3957 29.7756 40.7644 23.7808 19.8799 +3622 4 10.1982 39.3563 30.2561 -34.3316 0.809436 -14.8313 +3623 4 8.83679 40.1565 30.1832 5.55001 -15.1294 -12.8037 +3624 6 33.4099 4.77839 0.03236 -17.6047 -18.7695 14.8321 +3625 4 33.6454 5.53147 41.4176 15.8926 12.9618 -7.52592 +3626 4 34.0969 4.09847 41.8942 -0.186489 10.0102 -3.03658 +3627 6 35.7116 10.6673 34.2398 36.7653 -21.2814 -15.2586 +3628 4 35.2554 10.867 35.0388 -18.8422 0.575424 27.4634 +3629 4 36.4577 10.0619 34.4978 -21.6361 17.9445 -5.28322 +3630 6 15.2039 17.4016 19.1867 13.7018 -34.0248 -48.7675 +3631 4 15.5709 16.9982 18.3093 -23.7907 16.5473 43.0322 +3632 4 14.2523 17.472 19.021 -2.02403 4.48523 -0.714523 +3633 6 17.4757 37.6682 15.4227 -5.7624 0.927264 51.2416 +3634 4 17.0409 37.838 16.3209 3.67045 -5.85113 -35.7653 +3635 4 18.3529 37.3927 15.7202 1.879 4.38305 -13.464 +3636 6 26.263 8.20496 21.7043 -12.9193 13.0258 38.8746 +3637 4 26.2935 8.46487 22.6678 13.4631 -3.74504 -28.0146 +3638 4 25.3122 8.09558 21.5911 -4.90698 -1.77416 -12.6216 +3639 6 0.327844 9.89683 15.4174 -28.4002 -4.57955 -27.8061 +3640 4 1.20252 9.6859 15.1701 33.2298 -8.84956 3.25601 +3641 4 54.8213 9.3498 14.7471 -0.695723 21.8052 24.8209 +3642 6 13.451 40.6616 9.29616 -29.1589 -29.1317 3.11657 +3643 4 12.531 40.2581 9.2528 27.9164 27.237 1.6895 +3644 4 13.9533 39.998 9.7876 1.76749 3.89663 -1.50565 +3645 6 49.5605 25.9144 33.0102 6.77982 -23.7672 54.8124 +3646 4 50.0733 25.5846 33.8473 -25.1648 19.9091 -52.5505 +3647 4 48.6275 25.6453 33.15 14.5478 0.915879 -9.46863 +3648 6 37.0796 40.0419 26.4359 -26.9931 13.9721 12.3681 +3649 4 36.1882 39.5442 26.6099 42.8933 36.2545 -2.50818 +3650 4 37.051 41.026 26.6764 -12.8506 -44.3362 -9.04112 +3651 6 47.9916 17.8545 12.1553 -7.21137 29.6324 -37.7219 +3652 4 47.6652 18.6843 11.7058 6.42171 -29.0319 9.52509 +3653 4 47.7397 17.941 13.056 -8.12129 -2.80141 29.1943 +3654 6 27.9724 29.0571 34.165 6.45289 -21.5611 -2.40729 +3655 4 28.8948 28.8211 34.3683 -10.3018 1.8492 -2.91154 +3656 4 27.944 30.0064 34.1676 -0.713497 24.9251 0.854011 +3657 6 33.997 2.77014 13.2231 -35.3168 39.3397 6.14274 +3658 4 33.7592 2.40426 14.0871 -4.38792 -6.80294 -4.34532 +3659 4 34.7545 2.32608 12.931 40.4814 -27.3629 -5.76242 +3660 6 28.4454 36.033 11.4537 -30.811 -5.98685 22.1865 +3661 4 27.9997 35.3658 10.9161 0.521783 -1.73573 4.3727 +3662 4 28.9676 36.474 10.8303 31.7187 19.1344 -28.008 +3663 6 36.1836 11.3675 28.8638 -20.2526 -8.96451 -46.9053 +3664 4 35.201 11.3136 28.8426 17.393 5.15327 13.3727 +3665 4 36.3619 11.2493 27.8855 5.85658 3.26624 29.9739 +3666 6 24.7946 39.4802 16.9069 19.0937 3.96627 -8.4872 +3667 4 24.3751 40.345 16.9988 -5.97342 -3.52606 0.908874 +3668 4 24.9466 39.3518 15.9585 -10.9099 3.48913 2.54936 +3669 6 49.9504 8.05659 22.8451 -38.4139 -9.47108 -34.4931 +3670 4 49.9375 7.9588 23.7925 -16.1787 -3.75115 16.4902 +3671 4 49.0231 7.8493 22.4633 39.8101 3.17892 24.2331 +3672 6 52.1004 19.3469 10.2236 -1.12118 28.0811 1.24376 +3673 4 51.6057 19.3908 9.40186 -4.74475 -17.9853 -5.36861 +3674 4 52.3066 20.3081 10.2872 8.90847 -30.6944 7.30622 +3675 6 24.8344 15.8907 6.13046 -10.5287 3.62194 6.20212 +3676 4 24.2343 16.3288 6.78807 10.5214 -9.32926 -18.7028 +3677 4 24.4584 16.0701 5.24836 4.34413 4.47582 9.48796 +3678 6 49.3142 23.7074 8.6354 12.7826 -64.5552 32.8663 +3679 4 49.2168 22.9153 9.25307 13.1077 36.9849 -24.4484 +3680 4 48.4233 23.9587 8.46247 -20.5325 16.4959 -12.9251 +3681 6 0.200228 10.6387 32.1899 4.57462 9.08702 -50.3173 +3682 4 1.12405 10.3631 32.1441 4.84637 -6.06001 20.7538 +3683 4 54.8206 10.7585 33.0477 -1.25869 -8.0958 33.7963 +3684 6 12.5866 32.9145 13.2359 -45.84 -1.33101 12.3773 +3685 4 11.7384 33.4448 13.1799 26.1773 -16.8128 -1.90055 +3686 4 13.2757 33.4614 12.9111 20.4647 17.7705 -9.07485 +3687 6 21.729 32.5695 14.1172 -9.28791 -20.3928 5.37861 +3688 4 21.166 33.3661 14.1597 2.78901 -9.86158 3.94413 +3689 4 21.3002 31.8069 14.587 7.27427 31.5827 -10.8786 +3690 6 48.1522 34.8482 27.3304 1.15431 -17.6089 -40.5894 +3691 4 47.5385 35.1725 27.9994 -6.04073 -2.93057 -0.479876 +3692 4 47.6796 34.4132 26.5454 8.99615 21.2578 35.6726 +3693 6 45.6357 31.2393 36.095 -40.8957 20.4658 25.2026 +3694 4 45.8476 31.9489 35.493 1.2761 6.76392 -14.6383 +3695 4 44.8829 31.5945 36.6582 19.8537 -10.4851 -18.3708 +3696 6 46.2846 0.316369 14.3569 -23.6541 -29.5796 11.0344 +3697 4 46.2347 1.24867 14.1822 6.12226 14.592 -0.646978 +3698 4 47.172 41.8876 14.3137 22.6277 5.76419 -11.0491 +3699 6 14.3437 18.9821 40.2104 -25.2995 -33.3041 -15.9392 +3700 4 14.4094 19.2869 39.3238 4.54227 2.45102 -23.4893 +3701 4 14.593 19.7098 40.7196 18.3341 34.8836 33.2243 +3702 6 14.5595 1.13832 10.2184 21.0915 11.237 11.4523 +3703 4 15.4791 1.15983 9.85648 -24.9846 -0.242798 0.374642 +3704 4 14.0639 0.416501 9.81608 3.47586 -8.24251 -5.69878 +3705 6 34.4238 40.9137 13.0059 -4.24882 -26.6665 -25.0696 +3706 4 34.0907 40.4301 12.2099 6.6876 25.2293 12.1693 +3707 4 34.3655 40.2093 13.6737 -1.45879 20.9599 -0.365544 +3708 6 42.1372 25.6317 33.9946 32.9644 -29.1434 -4.32848 +3709 4 41.7256 25.3671 33.1599 -4.34041 1.82357 5.58197 +3710 4 42.8775 24.9612 34.1276 -26.6125 21.4128 -4.76888 +3711 6 29.2041 22.5904 40.0709 -12.2401 -3.24737 -11.2113 +3712 4 28.5312 23.0545 39.5673 2.40343 6.95864 -1.48823 +3713 4 29.0042 22.7646 40.9807 1.44808 0.219743 17.343 +3714 6 44.8039 18.6198 1.5029 3.83338 16.5679 14.3409 +3715 4 44.9659 19.0204 2.39019 -3.90529 -17.866 -14.3425 +3716 4 44.0478 19.1074 1.16429 2.25905 3.06151 -3.31671 +3717 6 4.48486 10.8191 23.9456 -47.6019 -35.9978 3.19751 +3718 4 5.13394 11.3869 23.6113 33.8353 31.137 -11.4748 +3719 4 4.52769 10.7271 24.8961 2.68899 9.9192 5.78369 +3720 6 6.46393 23.0191 29.0034 23.802 4.69353 23.6764 +3721 4 7.14249 23.0161 29.7285 -18.6834 17.7038 -21.9419 +3722 4 6.49076 22.0968 28.8008 -10.0115 -22.5628 -12.4771 +3723 6 39.7912 25.1434 32.5739 17.5205 -18.6836 -60.5647 +3724 4 39.6128 25.3468 33.4485 -16.6712 22.7672 53.7369 +3725 4 39.6667 25.9357 32.0325 -1.3786 -0.359445 4.68486 +3726 6 40.844 21.4875 8.87812 10.6958 -1.16061 -24.4784 +3727 4 40.753 21.3778 7.91779 -6.86728 3.07162 8.13114 +3728 4 41.3272 20.6946 9.13123 4.7165 -6.17308 11.2164 +3729 6 0.614957 1.42802 12.9561 35.282 30.4207 -35.1483 +3730 4 54.8795 1.90166 12.5287 -4.84596 -15.7095 11.3484 +3731 4 0.325279 0.716474 13.4972 -22.2917 -16.9379 18.816 +3732 6 32.6687 29.7155 23.4821 0.172893 -14.8348 21.3896 +3733 4 32.2937 28.8037 23.5347 8.27316 18.2339 -7.75927 +3734 4 32.5776 29.9928 22.5742 -5.86304 -0.191283 -15.879 +3735 6 12.5314 37.1515 20.4729 45.6241 64.5302 32.6184 +3736 4 13.0675 37.1561 21.3077 -14.1528 -0.638655 -18.1117 +3737 4 12.0966 36.3476 20.454 -27.4762 -63.6198 -6.10217 +3738 6 13.8924 14.5151 24.69 -3.15938 -4.02598 20.115 +3739 4 13.491 15.2498 24.2338 -4.44789 9.69439 -9.34194 +3740 4 14.0279 14.8194 25.6039 -0.281954 0.872924 -9.09093 +3741 6 17.5021 27.063 26.4741 18.9499 -7.93165 -17.7551 +3742 4 17.3645 27.9616 26.0981 5.20292 -20.1733 2.46217 +3743 4 18.105 26.551 25.8503 -19.0729 23.9469 15.4793 +3744 6 54.4877 9.53021 26.3477 -5.78247 7.96784 25.4661 +3745 4 54.0512 10.3733 26.628 8.34027 -15.1138 -9.49744 +3746 4 54.8923 9.139 27.1544 -8.60221 9.32804 -13.3813 +3747 6 33.6807 21.5011 24.9225 20.8165 12.7411 -37.5161 +3748 4 33.6447 21.5342 23.9109 -0.857654 -11.0597 35.2787 +3749 4 32.8481 21.1477 25.2212 -19.5227 -6.82771 5.56304 +3750 6 22.1475 35.2701 2.885 -1.57378 -2.18642 30.1771 +3751 4 22.1887 34.3602 2.5781 3.09514 -3.18559 -9.19859 +3752 4 22.1072 35.1817 3.87164 0.12039 0.813186 -18.6146 +3753 6 45.3027 5.41438 15.6133 24.4211 -32.124 17.7203 +3754 4 45.2073 5.06649 16.5292 -4.89018 16.6426 -14.7318 +3755 4 44.541 5.92364 15.3615 -17.3903 4.72304 -1.03383 +3756 6 5.67534 7.5869 16.981 -5.47297 6.8358 -20.2139 +3757 4 5.25896 7.81046 16.1225 6.35918 -0.232773 12.9215 +3758 4 6.51331 8.07041 16.9918 4.7107 -6.94883 2.60141 +3759 6 34.576 39.0992 27.2053 24.5889 13.5844 -33.9491 +3760 4 34.3093 38.4547 27.8221 -16.0328 -19.2876 29.327 +3761 4 34.0621 39.904 27.3046 -7.96056 4.01318 13.6593 +3762 6 32.7541 33.6107 34.2903 -12.2088 11.6467 -22.6039 +3763 4 32.1008 34.0277 33.6489 27.9813 -13.6615 23.3944 +3764 4 32.6574 34.0489 35.1447 -11.8345 -0.637226 -0.957772 +3765 6 31.0088 41.2052 32.3952 -16.5884 -4.13679 -5.08533 +3766 4 30.2065 41.1942 32.9317 -1.71273 -1.00977 6.80252 +3767 4 30.9738 0.147898 31.9828 5.47722 15.337 -6.15299 +3768 6 7.65161 1.58314 27.1492 34.9115 -9.04616 -23.8477 +3769 4 8.49581 1.43905 26.61 -35.9655 -7.00487 18.1392 +3770 4 7.51162 2.51613 27.0476 -4.48076 16.5289 1.77021 +3771 6 0.884173 22.0999 37.8474 19.5684 -22.3581 -15.9684 +3772 4 1.29289 21.3236 37.3582 -15.3878 24.821 16.8607 +3773 4 1.19208 22.8872 37.3739 -1.97361 -3.14502 -0.467946 +3774 6 7.41204 11.1157 19.2314 -38.1481 -15.0427 -1.85178 +3775 4 7.53858 12.0593 19.2468 12.5581 17.6457 8.19935 +3776 4 8.2604 10.6916 19.3015 17.9889 5.14781 -4.65775 +3777 6 43.7858 12.4956 37.3097 0.920036 9.73958 -3.1733 +3778 4 43.9612 12.5094 36.3537 -0.436236 -2.21513 6.60981 +3779 4 44.6264 12.7918 37.692 -0.443403 -7.75914 -0.361508 +3780 6 29.0868 33.5248 36.1867 6.33086 18.8505 -43.8567 +3781 4 29.87 33.99 35.8176 -18.9328 -5.41066 10.4629 +3782 4 29.4633 33.0358 36.8874 15.3521 -14.5291 31.9885 +3783 6 14.802 4.59099 3.93345 20.4849 22.8827 12.2406 +3784 4 14.3757 4.0439 3.27797 -5.14737 -6.71868 -8.73832 +3785 4 15.6594 4.91612 3.57855 -16.4986 -14.1515 -5.85747 +3786 6 39.0551 6.39795 6.38864 -31.6963 1.09254 42.8867 +3787 4 39.3692 7.21691 6.04781 17.6944 18.3081 -17.2196 +3788 4 39.3538 5.69048 5.84285 10.6785 -8.50098 -20.4551 +3789 6 22.2123 37.9977 40.776 -14.7699 -23.2033 -28.4168 +3790 4 22.4586 38.8695 40.5021 9.68098 25.7962 -2.3277 +3791 4 22.4791 37.9118 41.6765 7.85923 -2.07179 26.9545 +3792 6 4.44877 23.2867 6.14309 -1.92846 -21.7963 14.7751 +3793 4 3.85981 23.8785 6.59389 -8.34079 22.3777 -5.30491 +3794 4 4.15148 22.4458 6.53602 18.5324 -1.87236 -10.5169 +3795 6 12.4298 23.7885 9.24819 15.5635 1.24594 19.7483 +3796 4 11.6299 23.5219 8.81427 -22.2296 0.449899 -3.14002 +3797 4 12.2156 24.1823 10.1208 2.55292 -1.37139 -18.7826 +3798 6 46.4922 15.2589 16.9667 3.22745 3.94864 2.0367 +3799 4 47.1791 14.9867 16.3488 -1.59454 -10.7105 -10.6804 +3800 4 46.8221 16.1143 17.2497 1.89409 2.98219 12.0057 +3801 6 34.1117 27.1644 19.7797 24.4736 -11.2812 21.2279 +3802 4 34.8774 26.5238 19.7962 -19.6491 14.1094 -6.20677 +3803 4 34.0324 27.4806 20.6991 -2.21978 -4.312 -16.0235 +3804 6 46.9479 13.2121 35.1109 14.7829 18.0264 15.8687 +3805 4 47.3232 14.0654 34.8894 8.1348 3.75559 6.81177 +3806 4 46.5576 12.9943 34.2929 -17.7211 -19.0679 -23.646 +3807 6 50.5883 18.7922 12.536 -4.97475 -8.40096 -18.6689 +3808 4 49.7377 18.4417 12.2063 9.85466 0.19572 8.20723 +3809 4 51.2037 18.6585 11.7837 -7.44169 10.1395 9.07394 +3810 6 32.4871 12.6357 31.9554 3.75694 -28.5712 -45.9238 +3811 4 32.607 11.6542 31.8864 5.47128 21.8321 9.55763 +3812 4 32.4011 12.8494 32.8587 -4.02679 2.16968 41.7104 +3813 6 6.20502 19.6778 10.0162 1.71901 21.9334 16.0314 +3814 4 6.41826 20.2441 9.25697 6.75258 -1.0862 1.44387 +3815 4 6.08129 20.3112 10.7738 2.93045 -16.0896 -19.0741 +3816 6 21.5254 21.5246 2.44441 10.1652 3.23891 -24.6245 +3817 4 21.7373 21.5014 1.49425 -3.90993 5.22039 4.49463 +3818 4 22.0841 20.8004 2.76184 -10.1442 1.98878 12.5692 +3819 6 38.3901 23.0895 17.1987 11.9637 -29.1373 -23.0023 +3820 4 38.7115 23.1739 16.2902 2.30233 23.4463 5.8212 +3821 4 38.6091 22.1461 17.2941 -10.4226 8.48715 23.8901 +3822 6 29.6992 24.9636 22.2212 38.6917 -37.4999 -9.7813 +3823 4 30.2244 25.0209 22.9989 19.9484 -5.9881 25.7874 +3824 4 29.0295 25.5321 22.4534 -63.588 46.0104 6.14599 +3825 6 30.2959 21.4331 37.7732 -36.6703 24.7369 -1.55525 +3826 4 30.3833 21.3736 36.7928 -5.6984 1.01251 23.2154 +3827 4 29.3642 21.7906 38.031 44.833 -25.8334 -23.6526 +3828 6 11.8968 11.712 16.3062 -52.2626 -16.509 -42.1992 +3829 4 11.3487 12.2512 16.8737 -4.04714 4.99791 6.8918 +3830 4 11.2749 11.5458 15.4981 35.5887 6.11969 38.645 +3831 6 5.69762 16.9728 10.4703 1.06122 -0.586779 5.28994 +3832 4 4.99177 17.1708 11.0979 -1.96678 -11.04 -5.71485 +3833 4 5.85288 17.8179 10.0528 3.40155 4.97172 -3.96907 +3834 6 41.7052 34.1635 35.8846 2.77529 22.9845 38.2917 +3835 4 41.9958 35.0267 36.2582 -8.6238 -19.1969 -5.00662 +3836 4 41.6615 34.3005 34.9574 -2.57818 -0.630621 -34.674 +3837 6 33.7668 1.16041 30.1021 -7.73366 -5.3538 60.0773 +3838 4 32.8437 1.27671 30.3431 -6.56672 10.3256 -18.6068 +3839 4 34.0939 1.04339 31.0463 15.1522 -1.22783 -40.312 +3840 6 50.3589 18.6227 36.9888 29.2523 22.0538 -2.88024 +3841 4 50.1022 18.8636 37.8788 -6.7252 3.81489 7.59342 +3842 4 49.7597 17.9698 36.6907 -30.5426 -29.286 -11.4073 +3843 6 24.6818 24.2557 40.239 -30.3362 18.6852 9.52233 +3844 4 23.7683 24.4347 40.5809 21.1328 -2.57181 -5.50386 +3845 4 24.791 23.3075 40.3447 2.5826 -1.14956 -5.51696 +3846 6 37.3025 22.0306 23.2304 -1.24857 -1.55203 26.5345 +3847 4 37.0034 21.8174 24.1364 -3.77965 7.42086 -11.5868 +3848 4 37.7677 21.2337 22.9852 8.84969 -1.31238 -13.2672 +3849 6 48.4163 40.4951 28.9695 -6.68628 11.813 -16.9736 +3850 4 49.0084 41.2243 28.7075 -10.6266 -4.31108 -6.63999 +3851 4 47.6767 40.479 28.3098 12.2088 -0.876211 11.6705 +3852 6 24.8524 8.74511 16.566 -5.47802 -1.24744 16.6444 +3853 4 25.3154 9.32041 17.1898 2.58295 -0.80606 -7.28092 +3854 4 25.3735 7.93816 16.4942 1.51819 -5.71343 -7.74972 +3855 6 19.2312 23.0154 32.4581 7.29767 -10.2486 -2.08042 +3856 4 18.4295 23.4489 32.1618 3.75321 4.57429 -6.83594 +3857 4 18.9208 22.4103 33.1253 1.01223 -4.21105 8.69504 +3858 6 3.33807 21.6805 22.4551 -46.3933 -7.60477 16.0737 +3859 4 2.65604 22.1286 23.0335 23.3212 -20.9163 -13.0515 +3860 4 4.02869 22.318 22.3903 27.1551 13.0827 -5.07429 +3861 6 10.2258 20.3371 12.829 -8.54969 -20.6717 -8.68144 +3862 4 9.56384 20.8338 13.3253 4.28314 2.73019 -3.94148 +3863 4 9.70568 19.6401 12.367 8.3544 15.6282 9.01344 +3864 6 9.53393 0.668964 25.3385 8.23748 17.1946 -9.08311 +3865 4 10.3992 0.538209 25.8183 -20.1327 16.9559 -17.4439 +3866 4 9.57635 1.38514 24.6117 12.9812 -33.3008 29.4344 +3867 6 10.6624 40.712 9.64369 -16.6479 -8.09828 -30.6343 +3868 4 10.6692 41.3905 10.303 1.51816 10.4523 18.0663 +3869 4 9.97599 41.0031 8.99599 12.0328 -9.66263 16.6565 +3870 6 46.359 25.2248 32.6769 -14.7838 37.2607 37.796 +3871 4 46.1367 26.0735 33.2154 13.6855 -48.6436 -31.9122 +3872 4 46.6282 25.5659 31.8216 4.36769 -3.83668 -6.22015 +3873 6 38.9431 3.2028 23.1016 18.0409 -17.6687 24.963 +3874 4 38.0396 3.32435 22.9005 -28.138 13.963 -19.732 +3875 4 38.8834 2.64883 23.9052 13.1186 5.8311 -6.82495 +3876 6 33.334 23.6417 36.8871 -1.6197 -14.346 14.9842 +3877 4 32.7695 23.6175 37.7211 18.6046 10.6207 -30.6843 +3878 4 33.5528 24.5621 36.6745 -4.59115 1.63353 1.59233 +3879 6 51.9355 33.3272 25.435 24.4931 61.1901 -39.0042 +3880 4 51.4286 33.1494 26.1943 -20.5556 -13.8295 37.3068 +3881 4 51.9313 34.3506 25.3627 -2.33157 -52.0679 -5.38276 +3882 6 32.1777 25.0215 33.1655 -4.40266 21.2191 -9.05445 +3883 4 32.7541 25.8194 33.0841 -10.7751 -17.7804 3.95932 +3884 4 31.2703 25.3891 33.0319 13.5135 -10.8842 0.697404 +3885 6 51.2858 27.7149 39.5023 -29.438 -28.7732 26.1015 +3886 4 51.6029 27.7352 38.6212 16.0201 9.86215 -30.6452 +3887 4 51.6337 28.456 39.976 12.6328 17.4546 7.30145 +3888 6 34.2938 28.319 17.2582 8.1769 -6.30709 4.0332 +3889 4 33.5147 28.7567 16.9609 -27.2201 13.5182 -7.119 +3890 4 34.2215 28.3851 18.2119 5.48963 -10.3892 10.8325 +3891 6 36.9125 8.03614 37.8626 31.6258 41.6511 37.5008 +3892 4 37.1772 8.64874 37.1722 -6.23292 -16.4311 -22.0997 +3893 4 37.3691 8.52088 38.6203 -30.9712 -36.3395 -15.9768 +3894 6 34.8794 19.4073 6.12479 12.5531 6.66298 1.29528 +3895 4 34.0931 18.8687 6.15723 -9.84615 -2.81902 0.903663 +3896 4 34.5874 20.3343 6.07707 7.75337 -1.04832 -3.72421 +3897 6 52.9388 9.46792 7.82791 49.0384 32.8563 -49.3294 +3898 4 52.8922 10.1625 7.06425 -6.6048 -31.3865 41.9454 +3899 4 52.145 9.34409 8.30569 -37.6802 7.72308 13.142 +3900 6 36.3078 5.4787 38.9756 -59.3492 -35.3574 -23.3076 +3901 4 36.7604 5.44249 39.7856 34.2456 7.44664 27.0781 +3902 4 36.4713 6.28646 38.5283 19.3627 32.146 -13.2298 +3903 6 10.0102 14.4476 13.47 7.45507 32.9986 11.9551 +3904 4 10.2267 15.3574 13.7991 -6.33005 -21.0964 -5.42394 +3905 4 9.26267 14.5991 12.8847 -7.70629 -5.78085 -0.713961 +3906 6 17.2158 24.3617 39.7859 1.82925 -26.4802 17.5225 +3907 4 16.9252 25.2477 39.6578 -10.2532 23.1813 -8.78866 +3908 4 16.8659 24.1409 40.6742 12.3143 -2.49802 -8.33055 +3909 6 49.0708 32.5605 7.76617 4.98775 -19.9892 12.4117 +3910 4 48.2488 33.0406 7.85919 -4.66971 4.38963 1.84033 +3911 4 49.5854 32.9586 7.08254 9.03816 10.9607 -18.1455 +3912 6 44.8772 24.3958 5.47001 55.4245 15.4507 -4.26518 +3913 4 44.8128 24.5742 6.41303 -16.1158 -0.171295 7.10823 +3914 4 44.0866 23.9971 5.17679 -42.0653 -18.1716 -4.3799 +3915 6 37.3106 29.1913 32.8596 13.2918 -7.82588 25.4298 +3916 4 36.7195 29.353 33.61 10.148 2.43022 -0.346483 +3917 4 36.7915 29.3572 32.1043 -27.5405 3.64351 -29.7293 +3918 6 0.903259 24.8209 21.2384 21.1637 23.8586 -12.5999 +3919 4 1.07153 25.1845 20.3306 -6.36458 -4.90686 24.2304 +3920 4 1.48599 25.3539 21.839 -15.2813 -16.355 -7.82064 +3921 6 53.0335 2.20305 13.0061 -8.76459 0.917863 -30.1717 +3922 4 52.7178 1.83592 13.8181 -1.16689 -4.66991 20.3458 +3923 4 53.3973 3.07458 13.1779 4.70755 1.41814 13.7418 +3924 6 24.3073 33.9788 13.9425 26.9643 -19.8352 3.53447 +3925 4 23.8166 33.1535 14.1304 2.48225 11.7572 -2.64876 +3926 4 25.2622 33.8278 14.204 -36.1259 9.29052 -3.07765 +3927 6 40.931 19.3008 0.314297 -22.2267 40.7784 4.53314 +3928 4 41.073 18.3876 0.266006 15.5735 -49.6404 -1.39225 +3929 4 41.7685 19.7545 0.415523 11.1161 2.19254 -0.550631 +3930 6 38.3131 32.0321 21.5909 -11.558 27.6654 -12.3629 +3931 4 37.7152 31.3901 21.181 3.54948 -0.803384 -4.61225 +3932 4 38.0485 32.9451 21.2634 6.02672 -33.9485 15.0266 +3933 6 42.3093 34.9988 16.9782 -31.0886 21.3467 -4.04435 +3934 4 41.4322 34.9872 17.4259 23.1708 5.16072 -1.2535 +3935 4 42.7209 34.172 17.1456 10.0707 -23.8474 2.85212 +3936 6 19.5555 24.3301 21.9337 4.81064 -45.312 41.7565 +3937 4 19.0503 23.5208 22.2695 18.6897 32.4519 -16.5084 +3938 4 18.9494 24.7901 21.383 -21.2783 9.24005 -16.3011 +3939 6 21.0765 3.08453 14.9497 18.8565 6.62045 0.482113 +3940 4 21.9827 3.42458 15.1377 -20.4059 -2.71097 -2.70114 +3941 4 21.0593 2.94323 13.9894 -7.00518 -5.35814 1.95693 +3942 6 16.4422 12.1477 28.531 -0.750899 4.00912 3.87665 +3943 4 16.9503 12.6102 29.2147 -1.62139 -0.392447 -5.94721 +3944 4 15.8278 12.7952 28.1633 1.40376 -4.03425 1.22377 +3945 6 29.5501 4.7113 21.752 31.6763 -19.7408 -11.7502 +3946 4 29.7575 3.81476 21.3864 -8.62397 20.1371 9.94028 +3947 4 28.6767 4.97136 21.4837 -14.307 1.15287 -5.34284 +3948 6 47.4015 12.0887 13.4082 -20.234 -20.0739 19.2385 +3949 4 46.7896 12.1748 12.658 5.24956 2.33261 8.08179 +3950 4 46.8763 11.6307 14.143 25.8489 23.9178 -32.3489 +3951 6 26.4368 0.034911 5.58657 -64.7941 -10.5287 17.818 +3952 4 25.4579 0.386547 5.64311 57.7785 -5.53424 -8.5606 +3953 4 26.2825 41.0177 5.90114 11.1228 18.2746 -10.9356 +3954 6 20.8239 34.8091 41.3451 3.02448 22.7042 23.7072 +3955 4 20.8848 35.7307 41.7064 -1.83719 -23.2001 -12.5561 +3956 4 21.5135 34.3024 41.8142 -0.435548 5.34794 -5.15218 +3957 6 12.6914 17.4806 1.38079 -1.22179 11.8948 19.0955 +3958 4 12.6924 17.2614 2.32235 1.20892 0.120609 -3.36771 +3959 4 12.6119 16.652 0.923905 -0.609755 -13.5185 -16.0456 +3960 6 30.0783 10.198 8.41195 2.12134 -1.25171 -25.3141 +3961 4 29.3533 10.7626 8.0964 5.01977 -3.23694 0.534487 +3962 4 29.9182 10.0601 9.33268 -3.94599 -2.47727 24.1034 +3963 6 36.3506 5.44781 23.9083 -0.549638 14.3818 20.7021 +3964 4 36.0156 6.32048 23.6328 6.62881 -2.58855 0.476976 +3965 4 37.0027 5.63115 24.6267 -8.58297 -8.41851 -13.9364 +3966 6 34.0301 39.9488 19.4964 -23.0399 -20.8249 18.5921 +3967 4 34.456 39.4415 20.2152 6.93565 15.6495 -14.2212 +3968 4 34.6348 40.5483 19.0534 11.5364 2.12704 2.14354 +3969 6 25.0981 29.0133 17.0022 63.4673 53.603 -24.6749 +3970 4 24.4066 28.4545 17.2066 -49.3728 -47.1307 14.2315 +3971 4 24.9323 29.3693 16.11 -4.01222 -10.2038 10.3173 +3972 6 28.4991 21.3215 6.5284 30.3134 51.3135 12.4116 +3973 4 28.073 21.8131 5.82363 -12.0684 -17.0718 -17.6117 +3974 4 29.0439 22.0969 6.88435 -18.1485 -38.7813 5.23359 +3975 6 18.6639 26.1486 0.434559 17.278 41.4043 -10.2832 +3976 4 18.2934 25.3073 0.618971 -26.4426 -25.2614 5.85754 +3977 4 18.1648 26.8598 0.892557 2.28699 -17.4047 3.2853 +3978 6 10.9881 29.7025 15.4563 -76.0882 18.6105 19.9394 +3979 4 11.66 29.3744 14.945 58.6215 -25.2203 -34.7363 +3980 4 11.3165 30.0451 16.2682 18.0847 5.23212 20.5617 +3981 6 33.4842 3.75768 10.5858 0.636803 10.5574 28.6939 +3982 4 33.4734 3.50079 11.5612 -0.522502 1.02567 -36.066 +3983 4 33.5593 4.73652 10.6 -0.068286 -14.4363 0.33475 +3984 6 12.2823 28.8038 23.0281 11.3775 -6.29424 6.84391 +3985 4 12.7596 29.6284 22.9364 3.04418 8.52871 -1.54448 +3986 4 11.6562 28.9633 23.7417 -11.9653 1.92572 -6.97409 +3987 6 13.0879 10.2853 41.0171 -47.2786 6.02767 7.69694 +3988 4 13.8008 10.0588 41.5617 38.8858 -12.6991 24.323 +3989 4 13.445 10.533 40.1929 12.5253 9.31307 -31.237 +3990 6 45.8279 29.9763 22.3517 -19.0059 -47.3471 -0.794771 +3991 4 46.3385 30.6632 22.7121 22.9496 35.5749 11.5915 +3992 4 46.1736 29.1608 22.8005 -10.4716 15.4455 -15.9284 +3993 6 41.5587 12.1258 14.79 16.8952 2.46742 -19.497 +3994 4 40.8127 12.0778 15.3866 -8.88903 2.06539 11.4921 +3995 4 41.9001 13.025 14.8368 0.886253 5.83282 4.44761 +3996 6 18.1774 7.21532 24.17 -10.7079 71.0597 15.5191 +3997 4 17.3895 7.85304 24.2309 32.278 -29.8877 -8.26822 +3998 4 17.8432 6.3671 24.0218 -31.5603 -50.1252 -1.23769 +3999 6 1.46617 28.3087 7.5822 17.4051 32.8243 -18.4272 +4000 4 0.972435 27.5241 7.77639 -23.983 -7.56132 -3.64975 +4001 4 0.919057 29.0368 7.16413 8.17263 -22.6878 11.3207 +4002 6 11.3257 12.3178 24.0505 6.50608 36.5044 21.7543 +4003 4 11.787 12.9182 24.6663 -15.142 9.53056 -9.69028 +4004 4 11.7144 11.5384 24.3755 9.90684 -45.3393 2.97811 +4005 6 17.9727 40.4585 24.4268 -2.1753 13.4943 43.6914 +4006 4 18.2079 40.9973 23.706 15.3173 17.1897 -35.5256 +4007 4 17.8423 41.1404 25.131 2.16294 -27.9915 -10.5346 +4008 6 25.5983 7.44259 34.0136 19.3716 5.77393 -21.6373 +4009 4 25.8935 7.97324 33.2232 -7.88236 -13.8451 20.6491 +4010 4 24.6626 7.5793 34.1612 -12.3217 5.75259 0.6842 +4011 6 16.9533 36.3934 7.79695 -14.7733 -58.972 -15.2131 +4012 4 16.1509 35.7821 7.92089 32.5681 38.8119 0.0631702 +4013 4 16.873 37.2333 8.21975 -10.866 19.0251 14.3825 +4014 6 12.4478 39.1676 36.8063 -58.2746 -19.2691 -7.14825 +4015 4 13.2621 39.5728 37.0444 24.763 -2.90148 -1.94315 +4016 4 12.5678 38.2718 36.42 14.2903 21.5885 11.3364 +4017 6 23.4428 1.91286 37.7232 -9.22102 6.32267 -24.8838 +4018 4 22.7837 1.60923 37.0782 3.11058 2.78987 13.6287 +4019 4 23.6923 2.7833 37.361 6.97145 -2.92816 9.87668 +4020 6 26.6131 34.8527 39.0629 -0.358317 22.46 -5.08852 +4021 4 25.9211 35.0251 39.7209 4.63868 -0.642547 -8.45736 +4022 4 26.6245 35.623 38.4346 -11.8568 -25.3624 13.8384 +4023 6 44.7506 35.5772 23.1679 10.7298 -18.8811 -26.4233 +4024 4 44.6498 36.2622 23.8111 -7.39072 22.4611 10.5052 +4025 4 44.899 35.9413 22.2637 -2.27133 -5.1907 16.9936 +4026 6 34.6136 35.4178 26.71 -15.9342 1.46423 13.2724 +4027 4 33.7739 35.201 27.1682 15.3038 9.13482 -13.5788 +4028 4 35.2424 35.4667 27.4557 -1.55634 5.60609 -12.3698 +4029 6 12.4253 29.8367 9.37257 6.8074 7.71813 14.8361 +4030 4 12.5954 30.1793 10.279 -1.64518 -2.79843 -17.3301 +4031 4 11.9756 30.5342 8.87466 -2.55144 0.413422 5.70549 +4032 6 46.4578 41.3781 16.9525 -1.71223 -15.9012 -6.63524 +4033 4 46.309 0.164546 17.5847 2.66821 13.6546 8.2853 +4034 4 46.3887 41.8168 16.0911 -0.805017 -2.71613 2.08401 +4035 6 39.1753 31.0467 24.0118 -3.10819 6.08124 -21.6124 +4036 4 39.1065 31.2708 23.0301 -7.23524 -5.82233 36.9271 +4037 4 38.2867 31.0608 24.4123 9.52041 3.88051 -10.8568 +4038 6 40.5402 9.7597 28.9847 14.8037 -28.2595 -25.194 +4039 4 40.7176 8.78836 28.9335 -4.00485 22.4893 3.39032 +4040 4 39.9733 9.89103 29.7293 -9.65138 5.58475 19.0645 +4041 6 33.5593 11.9211 22.729 -1.15717 -3.69298 36.7387 +4042 4 33.4631 12.1387 21.8005 -14.8881 8.7456 -3.74916 +4043 4 32.9393 12.4796 23.2922 26.8098 -15.4098 -27.756 +4044 6 29.0159 38.7519 2.46278 27.6721 -15.5988 -40.3681 +4045 4 29.1586 39.6546 2.1748 2.74048 3.67355 2.54153 +4046 4 28.5501 38.8453 3.26351 -22.211 -0.421087 25.3577 +4047 6 51.2833 6.14739 28.3043 6.24107 -1.78447 -16.8419 +4048 4 51.6927 5.30788 28.0231 -4.79213 3.01935 13.8596 +4049 4 51.5671 6.73798 27.5888 -1.89698 -2.53529 10.4249 +4050 6 34.1064 16.6123 14.042 -37.0155 -16.4066 -7.07731 +4051 4 33.9904 17.5439 13.9588 -10.6946 23.5239 -0.125603 +4052 4 35.0244 16.4872 14.0391 48.662 -2.86898 -0.118382 +4053 6 34.4321 40.0645 7.48859 13.9518 5.57425 38.6209 +4054 4 34.6497 40.8416 6.93548 -15.3832 -25.9537 -5.407 +4055 4 34.0868 39.3056 7.01264 2.49953 7.17747 -18.8692 +4056 6 42.5297 22.9808 4.38266 2.56422 12.7755 -29.8183 +4057 4 42.7079 23.1404 3.43503 2.07895 -8.20356 9.72626 +4058 4 41.6007 23.2438 4.43282 3.68115 -1.88729 13.9368 +4059 6 1.41725 11.7089 10.583 40.9585 72.4956 7.82458 +4060 4 2.29602 11.7947 10.1149 -31.3121 -19.1762 2.07637 +4061 4 1.32217 12.6809 10.8959 0.250133 -47.8987 -12.0904 +4062 6 10.0222 17.1523 40.4009 -13.9984 -42.4532 23.0969 +4063 4 9.09922 16.7881 40.4362 25.3227 17.9847 -3.64852 +4064 4 10.5566 16.4623 40.9043 -11.7978 28.1532 -20.1855 +4065 6 26.3773 1.16785 23.7951 0.897687 17.1036 -20.4546 +4066 4 26.2949 1.59753 22.8926 6.72339 -10.2637 31.134 +4067 4 26.8106 1.83522 24.3632 0.404944 -5.36666 -8.232 +4068 6 4.47728 16.2319 39.0174 38.9165 -19.7518 -18.3291 +4069 4 4.60126 15.8787 38.0926 -3.95383 11.2541 23.7603 +4070 4 5.37849 16.1152 39.4714 -36.6531 9.54225 -13.0705 +4071 6 24.3645 39.8454 14.0862 11.6717 18.512 -7.42816 +4072 4 24.2179 40.7168 13.6655 -1.51261 -13.0973 5.973 +4073 4 25.144 39.5095 13.6466 2.38152 -7.3908 -1.6645 +4074 6 19.9724 19.004 10.1294 8.87966 -14.5095 2.71373 +4075 4 19.0999 19.3915 10.2782 -1.93643 -3.06257 7.63815 +4076 4 20.1403 18.2899 10.8137 -9.49435 28.7308 -18.8504 +4077 6 45.2455 15.0555 25.2985 9.44949 25.5865 29.6023 +4078 4 44.5225 15.6147 25.6238 -9.11717 -2.3226 -13.4673 +4079 4 44.9162 14.4027 24.6993 -17.0358 -18.2103 -14.0354 +4080 6 47.6513 32.9537 29.9733 -3.02769 -8.48031 15.1317 +4081 4 47.7848 32.4488 30.7976 5.01558 10.2706 -8.76515 +4082 4 46.6987 33.0693 29.9097 -5.02316 -0.316015 -4.02449 +4083 6 9.31033 14.1561 35.6305 -9.15199 13.4931 14.7277 +4084 4 10.2186 13.9515 35.3646 1.69372 -1.68405 10.862 +4085 4 9.25805 14.5533 36.5394 11.2175 -11.577 -22.5615 +4086 6 0.560208 28.7354 32.128 -23.2584 38.0618 20.8665 +4087 4 0.439761 29.1616 31.2639 2.79308 -8.58991 0.800302 +4088 4 0.67028 27.8063 31.9961 10.5465 -16.7679 -9.91325 +4089 6 26.1282 14.1993 40.8411 59.6454 -38.6249 5.43898 +4090 4 26.432 13.4524 41.4491 -20.3805 31.5142 -12.0858 +4091 4 25.201 14.2926 40.8644 -35.6636 2.31432 7.08225 +4092 6 38.0409 1.72795 37.3461 -15.986 9.3487 3.27435 +4093 4 38.337 1.77003 36.4219 -6.4212 0.733726 8.60438 +4094 4 37.1869 2.24333 37.3721 25.3175 -16.9011 -0.126137 +4095 6 43.391 21.0055 0.385428 11.1435 51.3868 10.1231 +4096 4 43.3728 21.9356 0.739051 -22.7765 -27.5137 5.23027 +4097 4 44.2566 21.1078 41.893 4.66373 -25.0138 -11.6612 +4098 6 29.7339 12.3948 17.084 15.7249 11.0657 13.1734 +4099 4 30.3928 12.9555 17.5239 -4.04604 16.1495 -27.1654 +4100 4 29.6387 11.801 17.8166 -19.321 -23.8097 4.84602 +4101 6 21.0831 10.9976 35.6454 20.8751 25.9078 26.8503 +4102 4 20.9144 11.9356 35.5 -2.5465 -0.914036 2.40284 +4103 4 20.6111 10.5739 34.9651 -17.7649 -25.2648 -31.6786 +4104 6 24.3635 22.1336 17.0651 -49.7832 5.03398 -16.9936 +4105 4 24.7447 22.8357 16.5516 14.0354 11.6369 -2.31656 +4106 4 25.0369 21.6158 17.4366 35.7007 -17.2122 18.4164 +4107 6 44.2543 9.63808 6.15039 20.313 -11.2139 14.5913 +4108 4 44.7688 9.46356 5.36091 -1.47318 -0.699349 -10.0319 +4109 4 43.371 9.9028 5.92157 -14.9065 6.10764 -5.2575 +4110 6 40.8032 2.87739 6.28666 -13.1289 22.479 10.901 +4111 4 40.3272 3.11809 7.09229 2.74106 -9.45257 -1.64817 +4112 4 40.5645 3.60702 5.69531 8.12536 -6.41414 -12.3146 +4113 6 23.4888 29.7691 25.1996 -20.8577 -7.3866 7.78845 +4114 4 23.0356 30.0691 24.4173 -11.1707 -5.96106 -7.76576 +4115 4 24.1981 30.3761 25.2406 38.2449 14.7306 0.541559 +4116 6 45.2336 20.6129 7.48752 -14.5833 -17.9538 -3.88696 +4117 4 44.4222 20.5961 6.94177 10.1673 3.83834 -0.615812 +4118 4 45.4226 19.6724 7.65027 4.1577 11.2609 0.378107 +4119 6 44.1804 26.5848 16.646 -7.77871 8.0927 60.0057 +4120 4 44.4497 26.5291 15.7549 9.82788 -17.3929 -39.3829 +4121 4 43.995 25.6977 17.0036 0.668911 -2.30329 -14.751 +4122 6 23.5902 27.0659 18.0913 -39.7013 -11.93 7.95298 +4123 4 23.083 26.2674 17.8176 19.208 11.4009 -9.44785 +4124 4 22.9184 27.4761 18.6801 25.6051 0.00742342 -8.40738 +4125 6 45.1467 16.0991 8.91755 -25.3782 -1.90264 -8.59791 +4126 4 44.1891 15.9425 8.7462 16.1978 6.4454 1.17339 +4127 4 45.2138 16.0078 9.87006 7.52298 -2.6657 10.2407 +4128 6 39.0203 15.1531 5.23259 28.6956 12.0263 -26.8074 +4129 4 39.7994 15.5772 4.7964 -10.087 -12.1112 6.39319 +4130 4 38.3368 15.7917 5.08662 -19.5574 10.6606 0.980846 +4131 6 40.468 4.77411 20.0927 -27.3359 -4.798 12.1592 +4132 4 41.2634 4.72652 19.6 29.6653 -1.38796 -18.2664 +4133 4 40.7147 5.23292 20.8909 -0.487482 4.30709 11.6637 +4134 6 35.8395 28.4372 39.9091 -50.8572 -25.335 -8.14583 +4135 4 35.0416 27.8127 39.7761 37.8149 25.8469 12.2999 +4136 4 36.4241 28.1912 39.1903 12.774 -11.5781 0.139918 +4137 6 26.5706 3.57143 2.67715 -46.9093 11.529 -12.2012 +4138 4 26.01 3.47498 1.86726 21.0232 -0.263485 19.1529 +4139 4 25.9795 4.13239 3.25499 25.5536 -16.3527 -3.3314 +4140 6 2.96374 21.6426 17.6806 -14.2306 -5.51577 -4.68338 +4141 4 2.93927 22.2072 18.4518 0.989431 6.72084 9.51867 +4142 4 3.70489 21.9005 17.1296 5.59779 10.8847 0.849605 +4143 6 12.8869 25.0552 25.9401 15.4127 26.4598 -14.83 +4144 4 13.2774 25.9118 25.6194 -5.06291 -21.1213 8.866 +4145 4 12.0842 24.9634 25.4247 -11.7493 -3.09829 -2.0396 +4146 6 41.5869 20.6707 14.1801 -22.4147 -6.05744 0.611169 +4147 4 42.2929 20.1295 13.8255 12.8925 2.43785 -7.39699 +4148 4 41.9118 21.5622 14.3536 8.70683 -8.7017 2.36606 +4149 6 1.26372 39.5934 11.5416 -2.31472 -23.2994 -17.666 +4150 4 1.60499 38.7626 11.0579 -12.721 36.8399 30.164 +4151 4 1.30151 39.4907 12.5143 8.15813 -4.07121 -11.1907 +4152 6 16.0274 39.0089 34.0759 -23.376 3.35378 -54.2756 +4153 4 15.5279 38.2654 33.6809 12.2329 5.59336 21.1278 +4154 4 15.9645 39.6681 33.3256 8.94624 -4.65522 31.8649 +4155 6 20.5749 7.01511 25.5545 -9.93748 22.9073 -1.77669 +4156 4 20.7998 7.9126 25.2373 7.69672 -13.5438 0.480138 +4157 4 19.6147 7.02086 25.4453 1.79337 -5.45304 -5.32881 +4158 6 45.1903 25.5946 39.1745 -26.3826 2.10768 23.1727 +4159 4 45.9078 26.0337 38.7511 23.0136 15.7961 -19.2282 +4160 4 45.315 24.6755 38.9972 4.74877 -22.0383 -3.82349 +4161 6 19.9254 40.1108 28.2935 0.936604 13.13 -6.83142 +4162 4 19.0415 40.3022 27.9603 -1.00367 -13.9734 -0.221352 +4163 4 20.1058 40.9072 28.8104 6.81084 -8.28794 7.10232 +4164 6 26.5025 14.2024 27.3816 7.55525 -11.5245 -39.7478 +4165 4 25.5661 14.1885 27.2241 -23.3405 -0.187867 -1.3667 +4166 4 26.5864 14.6167 28.2174 4.05242 7.69107 36.9512 +4167 6 51.349 25.9455 3.44193 13.1564 1.83251 -14.1309 +4168 4 51.0731 25.276 4.04973 -8.84751 -13.2679 15.0063 +4169 4 51.8098 25.4164 2.75525 -2.9574 19.5765 2.79729 +4170 6 20.1579 26.1269 2.66057 8.08543 -14.232 12.5138 +4171 4 20.4198 25.2285 2.95049 1.99012 13.1431 -7.88687 +4172 4 19.9848 26.1042 1.70984 -1.68704 0.137755 2.48294 +4173 6 3.12857 11.9594 27.2244 18.8731 20.7243 14.7894 +4174 4 2.60719 12.6622 26.8077 5.30838 -2.59233 -3.81502 +4175 4 3.76928 12.4285 27.8301 -19.9135 -11.7573 -12.7739 +4176 6 30.1745 26.3671 4.00755 44.117 -33.7612 35.926 +4177 4 30.7719 25.91 3.40695 8.20711 -11.5121 5.52432 +4178 4 29.6741 26.8182 3.4039 -49.0538 48.0497 -39.0484 +4179 6 19.309 20.6617 30.5327 -6.17305 20.3286 19.7257 +4180 4 19.3357 21.5037 31.0044 -16.2324 -1.53368 2.5841 +4181 4 20.215 20.6027 30.2783 24.1248 -10.9268 -16.9107 +4182 6 13.5428 36.2605 0.333332 15.0011 -10.6689 28.2547 +4183 4 13.9636 37.1467 0.274336 -13.564 -9.3403 -16.0521 +4184 4 12.8146 36.0991 41.6409 -4.77188 14.7057 -15.3617 +4185 6 13.69 21.7667 35.9665 -20.2473 -15.4187 -13.4538 +4186 4 13.4364 21.3658 35.099 7.7487 10.4825 13.8843 +4187 4 14.5406 22.1631 35.8296 17.4857 6.37333 -3.13554 +4188 6 39.4374 1.76506 25.3393 -36.4427 -7.29022 -10.5984 +4189 4 39.9364 2.34528 25.9215 16.7605 -3.08023 1.72977 +4190 4 39.8192 0.8892 25.1573 19.013 15.1682 11.727 +4191 6 18.3049 6.14326 35.8392 -10.8025 -19.5812 3.54688 +4192 4 18.125 5.32611 36.3393 4.50778 0.182671 -16.8727 +4193 4 18.2664 6.78418 36.55 10.3297 13.4079 -7.40032 +4194 6 2.50698 24.635 10.1008 2.82606 57.1639 14.1456 +4195 4 3.34783 24.2504 10.0645 38.9609 -42.7111 -6.9151 +4196 4 2.85647 25.509 10.4424 -34.1939 -15.4438 -5.60802 +4197 6 35.8245 9.94707 1.36321 12.392 22.5458 6.51215 +4198 4 36.2598 10.3662 0.602857 -1.03193 -1.33218 7.37913 +4199 4 36.14 10.4815 2.15194 -8.91958 -29.9524 -28.0328 +4200 6 29.0093 17.9332 41.5934 -7.9582 -11.0366 0.585828 +4201 4 28.5465 17.2289 41.1281 -16.7755 -3.81322 9.83818 +4202 4 29.6221 18.1453 40.9114 24.9254 25.1746 -10.164 +4203 6 46.0106 27.0842 25.8657 -15.8538 -10.6571 1.20957 +4204 4 46.7573 26.8966 26.4316 13.3887 1.52966 8.34957 +4205 4 45.3967 26.3449 26.0537 1.02353 6.85943 -7.5889 +4206 6 28.1115 10.6516 35.9124 -31.4415 -9.81676 -35.067 +4207 4 27.3321 11.0804 35.4953 10.9044 -14.8673 0.927998 +4208 4 28.4149 11.3158 36.4913 19.5717 24.3857 28.0975 +4209 6 25.9462 20.1874 24.7713 21.0981 19.7274 8.06252 +4210 4 26.7479 20.7296 24.6265 -12.3387 -9.71047 -3.27099 +4211 4 25.8934 20.1715 25.7373 -11.4252 -1.9185 3.65337 +4212 6 32.2315 30.2636 10.2038 46.2181 -42.2335 3.06511 +4213 4 32.6954 30.7903 9.55855 -13.4496 21.2522 -10.6663 +4214 4 32.9512 29.5744 10.3289 -28.7668 14.232 9.31608 +4215 6 5.05112 34.4033 23.8133 19.5013 -14.7597 17.0713 +4216 4 5.8904 34.9145 23.8209 -18.4686 -4.57798 -7.44977 +4217 4 4.4328 34.8283 23.2333 -4.78059 12.4432 -11.9709 +4218 6 29.6287 34.9421 23.1129 15.2461 20.4143 1.29823 +4219 4 30.2662 35.203 23.7945 -9.70178 1.77141 2.28452 +4220 4 29.7307 34.0083 23.0447 -4.13429 -24.1479 2.03513 +4221 6 52.1909 25.2296 36.2512 2.86438 -10.6824 22.6831 +4222 4 51.9483 25.3775 37.2028 5.23419 -4.07811 -26.4725 +4223 4 52.3343 24.2634 36.1804 -4.32722 6.81431 1.64545 +4224 6 6.96184 41.26 14.9825 2.80521 -5.8094 -40.534 +4225 4 7.04984 41.0874 15.8994 5.94782 -9.0625 22.8431 +4226 4 7.58542 40.6644 14.4953 -8.6815 16.2518 18.3581 +4227 6 27.6618 39.1341 4.65497 -15.321 -2.42325 19.5764 +4228 4 26.8583 38.6531 4.9607 13.8024 7.31782 -7.34321 +4229 4 28.2878 39.16 5.39008 -5.06496 -7.53921 2.22048 +4230 6 44.4448 15.8874 30.3939 -2.31018 0.103575 -22.4191 +4231 4 43.6353 16.4379 30.2788 15.6665 -12.4266 1.42045 +4232 4 44.7559 15.574 29.5018 -16.8402 11.4423 19.721 +4233 6 27.2939 38.1254 13.0955 15.3768 -40.6351 2.35664 +4234 4 27.6299 37.3572 12.5713 -6.06373 15.2601 5.99839 +4235 4 27.2975 37.7701 14.0147 -10.0522 11.5876 -10.9657 +4236 6 26.6773 32.9794 36.8294 -32.6396 -25.4624 12.1292 +4237 4 27.3491 33.5429 36.5103 30.2383 22.5556 -9.12925 +4238 4 26.1784 33.4868 37.4729 2.39424 7.35453 7.52648 +4239 6 26.3034 28.2003 31.7109 71.1077 16.3155 0.283388 +4240 4 26.8193 28.3341 30.863 -27.929 -6.55919 23.3278 +4241 4 26.9955 28.4613 32.4053 -35.143 -9.24619 -18.2719 +4242 6 49.2075 35.7729 23.3324 -21.4287 30.6035 9.89313 +4243 4 49.7648 36.3085 23.9054 5.92838 -6.84736 -0.0129328 +4244 4 49.7125 35.0813 22.9401 23.5965 -22.3057 -11.2126 +4245 6 44.2384 15.3735 33.5479 -0.546939 -12.4927 -0.897907 +4246 4 44.8734 15.133 32.8785 13.8917 -2.34347 -2.72297 +4247 4 43.5631 15.8174 33.0372 -7.79828 14.1806 -0.143619 +4248 6 16.6415 35.2629 14.0425 -13.711 -12.7272 -22.5016 +4249 4 16.8779 36.1297 14.3524 2.35153 17.3801 14.4176 +4250 4 15.7232 35.3535 13.695 18.4875 1.24889 7.88518 +4251 6 45.2979 21.4768 12.0753 -61.6802 -17.7786 9.36854 +4252 4 45.9745 21.1118 11.5746 47.2025 -15.5682 -31.9287 +4253 4 44.6407 20.7302 12.0307 13.4445 30.1014 15.4365 +4254 6 51.647 5.33893 20.0992 17.3373 6.85256 40.4731 +4255 4 51.8423 5.82757 20.9547 -12.0569 -16.4938 -26.4666 +4256 4 50.8652 5.75336 19.736 -8.70547 10.2387 -6.49138 +4257 6 22.616 27.3068 0.953729 -12.5585 5.72419 11.7926 +4258 4 21.9912 27.9206 1.39427 2.62886 -13.0847 -9.82719 +4259 4 22.9744 27.8285 0.229956 6.91293 3.08187 -2.36887 +4260 6 46.8924 12.1405 22.3241 28.0037 10.4006 6.07885 +4261 4 46.5361 12.6234 21.5839 -13.5229 3.11861 -11.9828 +4262 4 46.2058 11.655 22.757 -25.8682 -9.85748 8.02404 +4263 6 33.7577 5.61095 25.2306 8.81298 -10.6825 9.18366 +4264 4 34.4045 5.06092 24.7535 -5.77276 6.31779 -0.0821136 +4265 4 33.06 5.8369 24.6155 -4.37455 2.20678 -7.03208 +4266 6 44.2424 18.1337 27.2287 35.5912 4.17402 -1.61274 +4267 4 44.1428 18.6708 26.4104 -1.15401 -3.8952 20.8354 +4268 4 45.2041 18.2132 27.495 -32.4507 -0.562547 -10.2772 +4269 6 5.27745 36.9951 29.0779 -48.9341 45.2857 -18.2185 +4270 4 4.83797 37.847 28.7 19.7525 -41.2711 21.6555 +4271 4 6.18662 37.2124 29.1987 31.023 4.60304 7.81739 +4272 6 20.0415 5.02171 38.9415 13.5567 -45.1901 -20.6947 +4273 4 19.673 5.46942 39.6755 -5.65499 20.9205 26.8401 +4274 4 20.3443 4.13258 39.2728 -11.021 23.424 -4.53385 +4275 6 17.9077 2.77821 33.872 -28.7289 7.66476 22.1934 +4276 4 18.5675 3.36618 33.4993 11.2764 5.36232 -3.32863 +4277 4 17.289 3.30252 34.4687 25.3234 -20.0176 -17.8345 +4278 6 5.56252 23.3664 22.3199 23.4646 34.0494 22.6536 +4279 4 6.31266 23.4141 21.6995 -10.6272 -11.1368 -5.13028 +4280 4 5.83055 24.0852 22.9498 -18.4748 -15.0058 -11.9197 +4281 6 12.7366 28.0136 40.0786 16.9267 17.0007 -14.1953 +4282 4 12.7736 28.981 40.2539 2.04889 -13.1204 -10.7842 +4283 4 13.1752 27.8683 39.2015 -12.0592 5.90979 20.7524 +4284 6 50.5208 38.8121 28.4283 -2.96204 -29.3557 2.62021 +4285 4 51.1161 39.4306 28.008 -0.383593 20.3423 -2.32338 +4286 4 49.7133 39.2143 28.7877 7.69194 10.1621 -6.76025 +4287 6 33.551 8.21903 17.8634 -36.1599 -47.4859 45.2019 +4288 4 33.9333 8.85376 17.3385 32.2471 57.3944 -47.1321 +4289 4 33.8604 7.38657 17.5128 5.83122 -9.97324 -0.737685 +4290 6 34.648 34.7105 17.7828 9.01761 -19.7832 -8.77749 +4291 4 35.1788 35.3328 18.2888 -3.00831 8.66808 4.62333 +4292 4 35.2883 34.0014 17.5711 -12.5093 2.94991 -0.39307 +4293 6 40.7261 5.27864 23.3991 8.21105 0.19251 11.4926 +4294 4 41.4259 4.93717 23.9966 -11.2767 2.88733 -17.4667 +4295 4 40.0598 4.58084 23.2941 1.87831 5.06613 5.43463 +4296 6 16.9137 27.769 14.4809 73.6258 -34.7175 -8.82476 +4297 4 16.0667 28.1115 14.4612 -62.8462 32.6704 -2.60496 +4298 4 17.5486 28.5101 14.4313 -15.9271 -1.25076 7.8547 +4299 6 29.0219 14.6595 5.00786 20.8741 -13.5443 13.1138 +4300 4 29.536 13.8229 4.89138 -12.0375 16.0826 3.98067 +4301 4 28.8859 14.7576 5.97494 -2.91261 0.0620574 -16.4413 +4302 6 36.854 17.7325 5.08016 4.48522 -18.3735 -43.8449 +4303 4 36.2168 18.3553 5.39001 -11.7806 18.6728 17.0618 +4304 4 36.8305 17.8608 4.09391 11.7548 -5.76061 25.8999 +4305 6 27.7142 25.5094 34.8662 20.7401 -29.3529 -12.6468 +4306 4 28.3997 25.1535 35.4786 -13.7878 13.2187 -9.69645 +4307 4 27.3728 26.292 35.2699 -5.77421 14.8272 18.3022 +4308 6 24.7481 17.2805 18.0642 -3.31447 -10.4308 -2.46491 +4309 4 25.3087 17.9154 18.5049 2.27957 10.048 8.00722 +4310 4 24.0564 17.0505 18.7104 4.01172 4.3516 -6.8818 +4311 6 30.1789 1.58441 5.83411 4.12275 19.8646 -71.4749 +4312 4 29.4821 1.85802 6.42075 -6.9839 1.28517 8.89789 +4313 4 29.959 2.0434 4.91278 6.77151 -29.6581 61.3265 +4314 6 37.452 25.891 8.43789 -40.1641 -31.4732 50.6902 +4315 4 38.334 25.9927 8.78667 20.6785 -4.95116 -4.15592 +4316 4 36.9881 25.2791 9.14634 19.6253 32.8331 -49.0064 +4317 6 24.7604 7.00734 2.27008 32.0581 9.85747 -12.4546 +4318 4 25.4028 6.31463 2.48931 -5.40489 7.62931 7.6933 +4319 4 23.9158 6.58667 2.26874 -21.5893 -3.78057 4.11792 +4320 6 25.7887 38.8506 10.7619 -30.5475 28.1992 -59.3139 +4321 4 26.3103 38.4194 11.381 38.5207 -12.4255 48.7922 +4322 4 26.1525 39.7259 10.4932 -1.18865 -9.03037 15.3914 +4323 6 0.555207 13.578 28.1388 12.6332 42.7054 11.738 +4324 4 0.341766 12.7807 27.7179 -10.1825 -36.9478 -16.4943 +4325 4 0.413626 13.4435 29.0864 -5.17296 -1.28815 -2.85065 +4326 6 20.4105 17.1191 12.037 -17.9302 -38.4569 -26.5492 +4327 4 20.2295 17.2547 12.9605 -1.34068 5.07474 20.9983 +4328 4 19.8884 16.3005 11.7926 16.4515 20.0565 4.33162 +4329 6 30.9925 7.37797 16.6653 29.7996 22.3073 3.61878 +4330 4 31.2643 7.03844 15.7784 -2.63758 10.9944 17.123 +4331 4 31.7569 7.94595 17.0261 -27.6116 -29.8279 -14.8225 +4332 6 10.2093 5.78517 12.1714 32.5037 6.96704 58.397 +4333 4 10.1014 6.35617 11.4591 -8.08786 32.1119 -50.7901 +4334 4 9.65707 5.06197 12.024 -36.7963 -41.1043 -15.4671 +4335 6 18.4347 31.3493 24.155 3.48135 -6.25246 2.65688 +4336 4 18.4439 30.3878 24.2879 -2.95335 1.71216 0.944019 +4337 4 18.3198 31.7316 25.0273 -3.67252 2.09543 1.27238 +4338 6 27.8948 29.2525 29.2666 2.33504 21.8021 -21.5937 +4339 4 28.3627 29.5914 28.4251 -11.9103 -18.4763 37.4515 +4340 4 28.5196 28.9609 29.9463 14.9294 0.890267 -8.6061 +4341 6 38.3738 15.4456 29.791 12.9945 -28.6313 15.0543 +4342 4 38.0891 14.5036 30.0544 22.1369 39.5396 -7.74746 +4343 4 39.2957 15.632 30.1541 -37.4531 -3.97597 -10.3113 +4344 6 21.7041 34.7992 5.56934 -10.1436 -56.1371 25.2208 +4345 4 21.4621 33.8673 5.89439 16.7439 32.0975 -19.9868 +4346 4 20.9431 35.2741 5.907 -2.46203 13.3807 -4.97838 +4347 6 18.2064 16.8274 1.01093 1.02147 5.09087 9.91972 +4348 4 17.6405 17.264 0.353478 -0.489627 -6.58546 6.49815 +4349 4 17.8529 17.0628 1.89865 0.517006 0.361128 -13.8735 +4350 6 43.5166 18.4972 39.3436 16.5286 13.9247 -42.0759 +4351 4 43.0101 19.1966 39.7112 -21.9319 15.1254 24.622 +4352 4 43.7095 18.933 38.4597 1.00685 -29.3013 20.2287 +4353 6 17.7976 10.0688 35.5434 7.86102 19.599 -20.2005 +4354 4 17.8945 9.40709 36.2105 4.74187 -18.2058 11.3424 +4355 4 18.5459 9.97323 34.9151 -16.2901 -5.18221 9.2364 +4356 6 36.5889 30.5599 29.0828 -33.0481 48.6405 -12.465 +4357 4 36.5132 31.4977 28.7143 1.54088 -37.0728 8.50934 +4358 4 37.4982 30.324 28.9756 25.7485 -11.7594 -3.68806 +4359 6 38.4943 35.9682 10.4222 10.3079 16.2999 40.226 +4360 4 38.6552 36.6966 11.1228 -3.33458 -34.9071 -25.8136 +4361 4 38.3509 35.1294 10.9235 4.16648 17.1849 -3.98913 +4362 6 43.4036 18.8037 34.3607 -18.7725 -42.8138 41.3108 +4363 4 42.9709 18.1893 33.7432 11.3097 10.906 -2.86187 +4364 4 43.2777 18.3171 35.2411 6.94038 29.5352 -30.5758 +4365 6 11.0585 40.2128 6.10885 -15.7783 5.94868 1.16987 +4366 4 11.5965 40.9262 6.45194 10.3679 4.26541 4.32644 +4367 4 10.1443 40.5526 6.13585 6.40705 -5.05479 -5.29954 +4368 6 48.3342 13.7493 24.4707 -3.46168 30.4962 28.8754 +4369 4 47.8576 13.3588 23.754 -13.8134 -6.92474 -20.9085 +4370 4 47.8711 14.5963 24.7134 14.7345 -25.1065 -10.1999 +4371 6 1.47205 25.7712 23.7829 0.184952 23.7651 -2.41746 +4372 4 0.854396 26.4618 23.4919 -3.79407 -11.1699 -2.17794 +4373 4 2.13056 26.3319 24.2122 9.67536 -12.9921 7.11562 +4374 6 20.5856 0.045789 21.1048 4.96875 -22.7073 -7.43464 +4375 4 19.8117 0.249922 21.5931 -19.4423 21.7426 16.1957 +4376 4 20.4519 41.001 21.0443 13.8042 -0.350206 -3.82588 +4377 6 37.6675 12.896 30.7055 18.9575 -14.1068 -43.1025 +4378 4 37.1872 12.5493 29.907 3.14127 2.53034 24.3729 +4379 4 37.0391 13.1763 31.3358 -31.377 6.23238 20.3235 +4380 6 49.4665 17.3801 9.24655 -8.32961 25.946 -15.5009 +4381 4 48.5345 17.665 9.32633 16.3924 -11.5392 1.15372 +4382 4 49.8219 17.9883 8.54454 -1.98957 -21.6031 19.5257 +4383 6 34.3643 5.3502 17.1421 32.952 7.78829 -18.2658 +4384 4 34.6245 5.26975 16.1857 -14.4704 2.64329 20.4158 +4385 4 33.4298 5.20109 17.2262 -20.6176 -11.2241 -0.901893 +4386 6 14.7832 27.6655 0.085624 -10.3553 13.8949 -22.792 +4387 4 14.1034 27.8892 41.3249 2.03342 -11.2849 14.5146 +4388 4 15.1757 28.5319 0.287496 2.39463 -6.00136 9.68974 +4389 6 48.8635 15.5211 20.7504 -7.30397 3.37214 15.1279 +4390 4 49.1252 16.3754 20.4371 0.183023 13.7927 -3.76167 +4391 4 49.1585 14.9241 20.0762 3.93917 -17.6947 -14.7742 +4392 6 23.8074 40.3851 20.3877 -2.3041 21.5375 32.1864 +4393 4 23.5266 40.991 21.1382 8.45078 -18.9812 -28.3519 +4394 4 24.6929 40.0818 20.645 -4.8729 5.63426 -4.96266 +4395 6 35.18 31.4993 13.7142 -38.6695 32.0432 -41.3249 +4396 4 34.2219 31.3119 13.4889 30.0091 9.93153 3.95626 +4397 4 35.4367 30.7845 14.243 12.3636 -35.8089 30.5679 +4398 6 10.9775 9.01115 39.5206 -26.3812 35.8658 -19.2594 +4399 4 10.5557 9.91556 39.5205 15.5031 -28.3669 -8.85108 +4400 4 11.1542 8.87096 40.4393 5.31517 -3.54045 10.232 +4401 6 53.2061 4.88103 16.6049 -20.6689 -12.7794 3.6937 +4402 4 53.6782 5.3887 17.2239 33.7717 25.1716 19.5104 +4403 4 52.5676 4.51498 17.2255 -11.3933 -13.1169 -19.2452 +4404 6 7.83562 33.8039 26.1496 42.0062 50.3869 -17.047 +4405 4 7.62463 34.1533 27.0155 -6.33847 -9.39794 9.82588 +4406 4 8.42034 34.5749 25.7852 -30.6961 -50.8642 6.91563 +4407 6 31.3279 27.9472 6.28298 4.37835 -19.3247 -9.6219 +4408 4 31.922 27.5111 6.93657 -10.4846 5.09347 -11.9486 +4409 4 31.1129 27.3323 5.53276 6.79934 9.76999 15.6259 +4410 6 31.3655 2.17383 41.055 18.9421 -1.98994 34.5993 +4411 4 31.8109 2.17902 0.04034 -17.0754 7.04602 -28.7946 +4412 4 31.2404 1.23747 40.9086 -7.00813 -7.80206 -8.22245 +4413 6 33.7652 4.25739 35.9001 -31.2863 -13.3655 20.8802 +4414 4 34.2485 3.80076 36.6104 5.56552 8.36292 -9.80816 +4415 4 32.8077 4.13792 36.1863 30.7439 3.51509 -16.9094 +4416 6 47.9725 16.0636 29.8584 -12.289 -4.0311 -5.35812 +4417 4 48.7208 16.4163 30.3732 -4.13056 -10.8519 0.408936 +4418 4 47.3533 15.5947 30.4559 16.7379 8.85318 -0.563064 +4419 6 49.3385 10.0935 28.5885 -11.8118 4.56009 -13.0989 +4420 4 48.5886 10.6638 28.8239 3.51911 -4.5157 1.44109 +4421 4 49.3924 10.1159 27.6088 6.69909 -1.91925 15.8757 +4422 6 21.4187 27.7693 29.76 2.80336 -20.4787 -6.37736 +4423 4 21.861 27.2354 30.4624 -7.84738 15.6574 -13.8161 +4424 4 21.1828 28.6282 30.0799 2.10219 20.3695 17.9057 +4425 6 11.6757 39.482 25.8517 13.5538 20.9417 -1.29545 +4426 4 12.2965 38.7786 26.0889 -7.12508 -2.9493 -2.05027 +4427 4 10.8193 39.0846 25.7116 -11.9056 -6.20494 0.0112269 +4428 6 22.9798 39.311 7.85817 -12.7601 -4.86939 -3.04246 +4429 4 22.3059 38.6219 7.95844 1.92638 3.98273 0.136758 +4430 4 22.5772 40.0658 8.31757 9.04497 -1.85468 3.82529 +4431 6 42.5415 35.9278 31.3391 13.0935 -70.9729 -20.1514 +4432 4 42.6447 35.4696 30.4714 -5.52665 5.17936 25.8951 +4433 4 42.5102 36.7973 31.0384 -8.93799 60.9387 2.27408 +4434 6 33.663 14.7412 3.98499 30.4225 -17.693 -39.6888 +4435 4 32.8564 15.2185 4.09596 -24.3526 16.5192 2.50389 +4436 4 33.8944 14.7916 3.00116 -11.9532 1.40502 32.6284 +4437 6 36.697 8.6017 17.5153 18.7294 -29.9333 -4.55465 +4438 4 37.1702 7.95911 16.9159 -11.687 24.5338 13.7544 +4439 4 36.2734 9.25409 16.9543 -7.54123 3.80926 -6.08989 +4440 6 20.8295 32.4146 17.3309 -48.7404 -21.5825 11.0081 +4441 4 20.1664 32.9726 16.9048 10.2664 9.72211 -3.82622 +4442 4 20.2271 31.8015 17.8465 35.2036 12.7196 -8.50107 +4443 6 20.7003 35.3218 14.1083 -3.44914 -18.0461 -19.2112 +4444 4 21.3182 35.5386 13.4099 3.08163 2.90557 -13.4495 +4445 4 20.919 35.9437 14.7754 1.56244 13.5022 22.2067 +4446 6 20.2323 2.51936 40.1651 -9.22326 -14.3688 36.1644 +4447 4 19.7926 2.34354 41.0434 13.5524 6.30823 -28.5037 +4448 4 20.7516 1.7186 40.0171 -1.27786 1.50094 -7.75906 +4449 6 15.0477 14.4672 0.24789 12.9865 -5.55034 -72.7807 +4450 4 15.4827 13.6954 41.6877 -12.87 20.0829 29.6139 +4451 4 15.2186 15.2036 41.5094 -2.93016 -13.2387 23.097 +4452 6 24.8149 37.3373 18.5213 2.43631 -2.68492 27.9859 +4453 4 24.4361 37.9203 17.8611 -0.249038 9.91659 1.71419 +4454 4 24.5604 37.6468 19.4234 0.486379 -6.00228 -23.279 +4455 6 3.16989 27.7944 5.24229 1.80682 -16.6913 61.515 +4456 4 2.664 27.92 6.09489 -0.254446 2.50987 -32.3978 +4457 4 4.0252 27.4816 5.63916 -14.135 1.37322 -28.2843 +4458 6 37.1257 39.0598 36.0573 4.58816 40.5807 23.3296 +4459 4 37.5599 39.5885 36.7783 -22.7086 -1.13864 -22.8071 +4460 4 37.5439 38.2379 36.1828 13.5973 -37.3165 -5.96047 +4461 6 41.3477 16.3672 3.84024 25.8131 6.72768 37.2631 +4462 4 41.4431 17.3182 3.89206 -17.3786 8.01961 -13.1803 +4463 4 42.0046 16.1549 4.54461 -14.0821 -19.2698 -21.0799 +4464 6 15.5755 3.1684 35.3585 1.47298 2.70845 -61.2084 +4465 4 15.1145 3.59171 34.5864 10.479 -16.2188 17.3147 +4466 4 15.2032 3.60881 36.0782 -15.9672 22.7619 40.5269 +4467 6 33.1731 24.2438 7.96729 6.41569 -10.7526 14.1331 +4468 4 33.3408 24.6773 7.1445 11.9115 -7.07525 -26.7187 +4469 4 32.5824 24.8707 8.33408 -19.4303 14.6961 21.7816 +4470 6 35.865 29.7374 15.5979 -29.8607 35.3275 -32.1308 +4471 4 36.7747 29.6672 15.7703 43.701 -12.5229 16.5971 +4472 4 35.3562 29.0371 15.9739 2.56537 -15.478 18.0667 +4473 6 17.5843 36.8354 41.8728 12.1708 -5.57123 -52.5088 +4474 4 18.1833 36.773 0.675699 12.2604 -1.93512 36.5948 +4475 4 18.2359 36.8623 41.125 -21.8566 7.06165 11.6698 +4476 6 26.5622 4.14672 31.1307 -32.6289 -51.1506 -31.7953 +4477 4 27.2582 4.59627 31.5457 41.9615 24.0313 17.3243 +4478 4 26.8928 3.23766 30.8727 -4.86114 29.783 15.5489 +4479 6 31.9552 1.33198 34.4369 -14.3248 -8.90334 35.5546 +4480 4 32.7269 1.15305 34.9944 8.32726 6.02564 -17.2377 +4481 4 31.2642 1.08685 35.0838 -0.545778 4.81468 -20.3916 +4482 6 24.491 14.7534 2.38457 33.2042 -23.9469 17.2683 +4483 4 24.2753 13.9637 2.92779 -7.56186 18.0622 -11.5291 +4484 4 25.4626 14.8414 2.55985 -20.2114 8.54272 -9.97318 +4485 6 25.7566 20.9055 27.5389 -1.15091 7.1508 6.95521 +4486 4 25.459 20.6057 28.4261 8.17968 -1.38894 -17.9407 +4487 4 25.6371 21.8685 27.5748 1.97223 -1.15564 -2.97875 +4488 6 18.1445 40.1527 30.6395 17.3729 -20.3781 15.2884 +4489 4 18.5141 39.2638 30.8544 -10.5973 16.1604 -9.36512 +4490 4 18.9393 40.7073 30.6583 -6.94059 7.54086 -5.9327 +4491 6 46.7889 23.8914 24.5979 7.31075 41.4222 -46.8858 +4492 4 46.2898 24.602 24.0741 10.6002 -32.8666 22.2289 +4493 4 47.4121 23.5287 23.9473 -6.99108 -0.957122 4.26591 +4494 6 45.6201 22.6921 26.5067 -14.1777 -10.0967 -12.8229 +4495 4 46.0372 22.9342 25.6668 -2.41585 -1.26552 16.8561 +4496 4 46.0784 23.1676 27.2003 -0.61408 1.28207 1.11474 +4497 6 20.1006 4.48803 26.6974 -40.8522 40.1383 42.8029 +4498 4 20.2489 5.43817 26.4853 8.37449 -26.4011 -0.951475 +4499 4 20.6602 3.93368 26.2205 34.0606 -24.4352 -38.1565 +4500 6 35.278 26.5864 12.552 0.280065 20.4825 10.9931 +4501 4 35.6728 25.7022 12.4634 2.08478 13.3641 8.87461 +4502 4 35.7774 27.1222 13.2104 -5.20465 -19.6779 -15.4464 +4503 6 3.25879 33.9669 12.2907 -5.01808 -25.4739 5.3677 +4504 4 2.34263 33.6224 12.3201 4.20809 12.7539 -0.381501 +4505 4 3.26735 34.9165 12.3326 -4.58918 17.9212 0.78916 +4506 6 36.6873 1.27899 25.5756 -31.8717 2.25298 32.7844 +4507 4 37.6116 1.37326 25.7779 18.4499 5.6721 -4.77344 +4508 4 36.2122 1.51788 26.4163 6.97172 -2.04149 -25.7728 +4509 6 16.8705 4.65685 24.0413 -35.5309 2.76318 -23.9776 +4510 4 15.8575 4.70434 23.9217 47.0687 -0.0954558 1.21401 +4511 4 17.247 4.33879 23.186 -5.50277 -2.28941 17.9023 +4512 6 39.6565 15.0715 7.80572 25.6093 19.6796 32.1194 +4513 4 39.2854 14.2576 8.13712 -9.42359 -13.1845 -9.18942 +4514 4 39.3628 15.2517 6.91527 -5.26665 -12.4192 -5.15573 +4515 6 9.97948 20.1659 2.91877 -9.38613 14.9664 11.2777 +4516 4 9.63877 20.6452 2.15027 4.12295 -11.9706 -3.67253 +4517 4 9.85969 19.2106 2.80597 1.71997 13.0916 -4.74013 +4518 6 23.4135 4.6314 15.2717 1.19087 -47.3757 24.1847 +4519 4 23.6596 4.57091 14.3636 3.27412 12.4021 -25.8415 +4520 4 23.0767 5.481 15.4712 -5.64379 31.4202 -0.243197 +4521 6 23.5143 41.6409 17.9193 15.1077 8.25095 -6.6202 +4522 4 23.8837 41.2632 18.7444 -17.9015 4.85421 -1.14363 +4523 4 22.6477 0.129763 18.1032 2.89941 -5.9973 3.37217 +4524 6 30.9257 4.8197 1.33225 52.4556 82.2644 21.8498 +4525 4 30.6067 4.04082 1.0087 -28.5575 -73.6424 -29.1188 +4526 4 31.8008 4.99709 0.898826 -20.2281 -12.9509 7.44496 +4527 6 29.2107 33.7595 18.6102 73.0072 -21.2941 -2.29721 +4528 4 30.2072 34.0216 18.5444 -47.9733 -6.17517 5.28057 +4529 4 28.7323 34.5281 18.37 -21.0864 31.3556 1.11974 +4530 6 23.1159 16.7161 3.6681 15.0693 -22.2232 4.2808 +4531 4 23.7494 16.3853 2.99745 -15.1451 3.0429 8.25243 +4532 4 23.0882 17.666 3.59926 -2.15966 11.8771 -4.335 +4533 6 34.9011 26.7664 31.7501 -1.76717 8.52767 -40.8429 +4534 4 35.037 27.6398 31.3273 1.29043 -2.59798 26.5044 +4535 4 34.999 26.223 30.9552 -0.698038 -3.54606 8.98008 +4536 6 7.10213 40.7731 20.9713 24.4432 1.2064 -5.23395 +4537 4 6.57619 40.3882 20.2802 -20.054 -4.79313 -9.64846 +4538 4 7.95521 40.8692 20.51 0.818491 4.17448 7.60026 +4539 6 52.4557 9.69054 11.9333 -13.8891 -19.4181 -13.3487 +4540 4 52.1298 8.88818 11.4535 9.48574 25.0976 13.8313 +4541 4 53.1611 10.0725 11.3936 -7.122 -1.8527 1.23238 +4542 6 12.0235 32.7598 27.7442 3.70099 -7.78602 -3.89203 +4543 4 11.3626 32.1501 27.3892 -5.86407 9.3821 3.02313 +4544 4 12.7405 32.6461 27.1218 9.18069 3.19616 2.31322 +4545 6 15.7918 18.546 0.850378 10.8461 -1.95532 -11.5883 +4546 4 16.438 18.9813 1.41668 1.29405 -2.87095 0.147979 +4547 4 14.9753 18.6242 1.3119 -21.1882 -0.0291689 9.92309 +4548 6 30.9967 13.9378 7.42939 11.475 1.61738 -44.5395 +4549 4 31.0432 13.5913 6.48715 -7.7997 1.97415 36.5778 +4550 4 31.6719 14.6391 7.43931 -7.46887 -7.66354 10.6483 +4551 6 23.9383 39.564 3.55488 34.3001 -22.0749 -10.0269 +4552 4 24.3437 38.8163 4.07249 -17.2972 16.8542 -11.2744 +4553 4 24.6493 39.7352 2.88999 -19.8697 7.819 10.5959 +4554 6 53.2452 13.9576 2.00229 -14.7116 -5.90049 -8.44118 +4555 4 54.0493 14.3984 2.24709 19.6807 0.169927 9.22775 +4556 4 52.9645 14.4205 1.20429 2.95034 -7.59818 -1.70329 +4557 6 29.4557 26.4275 7.80964 12.1022 6.02758 -9.79702 +4558 4 29.9353 26.7368 7.00545 -17.6775 -4.91001 19.2628 +4559 4 28.525 26.2807 7.58748 -5.08244 6.84096 -3.37299 +4560 6 24.6247 23.6022 31.0889 -22.8452 23.3962 -39.3716 +4561 4 23.7242 23.1866 30.9343 31.0198 16.8155 5.56769 +4562 4 24.7802 24.3072 30.3632 -7.32447 -41.3429 34.091 +4563 6 33.6649 19.3163 40.5091 -6.65541 -1.27585 7.81728 +4564 4 33.8354 18.657 41.2044 -1.67667 1.74775 -3.87809 +4565 4 34.3105 19.1562 39.8145 2.0445 4.20075 -4.1701 +4566 6 0.559384 35.9874 14.2134 5.8565 -19.6842 -1.82955 +4567 4 1.23941 35.9463 14.8996 -3.202 15.0395 2.84586 +4568 4 0.030681 36.7785 14.2979 -4.01885 14.7851 6.49139 +4569 6 7.05661 12.759 15.7779 -22.8667 -6.52104 17.6379 +4570 4 6.34583 12.5966 16.4564 20.9558 0.33122 -21.552 +4571 4 6.91757 12.0848 15.0954 -2.34629 3.44815 6.08752 +4572 6 7.88282 3.87818 22.4173 5.89555 -44.5054 15.1514 +4573 4 7.49019 4.56914 21.9267 -7.80716 26.896 -25.5563 +4574 4 7.61791 3.03791 21.9647 5.08594 18.6769 15.1101 +4575 6 50.7471 32.0888 16.2401 1.83727 42.1646 -7.06137 +4576 4 49.8752 31.8312 16.5285 -7.29916 -4.21179 -0.512004 +4577 4 50.6362 33.057 15.9791 5.96194 -37.4522 8.78354 +4578 6 15.303 18.2089 30.059 10.7923 -22.0796 25.2673 +4579 4 14.9011 18.5061 29.2675 -14.0638 14.0876 -27.3921 +4580 4 14.9173 17.3208 30.1974 9.34767 8.93092 3.04247 +4581 6 36.7231 25.4597 33.3812 -54.2725 16.2506 -34.9161 +4582 4 35.9173 25.838 32.8237 55.5216 -11.0114 39.6871 +4583 4 36.747 24.5432 33.1027 5.79642 -6.85026 5.14009 +4584 6 16.5358 21.8507 20.2615 -17.2006 3.10996 -10.5852 +4585 4 16.5318 20.9271 19.9881 4.62491 -6.39719 -1.16283 +4586 4 16.2171 22.3466 19.4835 8.40466 -0.269645 8.83911 +4587 6 44.2784 3.11614 30.075 -4.29151 -10.9085 31.9498 +4588 4 44.2908 2.23086 29.7056 -5.3385 -9.83615 -1.81045 +4589 4 44.5205 3.68982 29.3775 9.49019 22.102 -29.428 +4590 6 51.0822 14.1295 27.7742 -18.732 -33.3382 -1.30318 +4591 4 51.215 15.0658 27.7997 -1.99026 24.8352 -0.164216 +4592 4 50.1181 13.9695 27.6298 18.0185 9.91077 0.913588 +4593 6 54.1414 15.8836 27.1251 18.1892 -50.717 -21.9912 +4594 4 54.5758 14.9905 27.2793 -7.90108 34.3346 13.352 +4595 4 53.8259 15.7459 26.2068 -12.5208 17.6482 15.4671 +4596 6 26.7107 15.1629 34.529 26.3006 32.6175 -12.2305 +4597 4 26.7089 16.144 34.4655 -8.86078 -18.0829 7.52702 +4598 4 27.5163 14.9973 34.009 -10.4907 -11.0891 -0.654257 +4599 6 34.6699 2.22267 27.4725 27.1341 -12.2799 29.337 +4600 4 34.3153 1.93716 28.3227 7.08088 3.88889 7.09202 +4601 4 33.8991 2.25298 26.9555 -28.541 9.30381 -28.496 +4602 6 36.3083 17.6409 40.3953 7.68303 1.60807 9.57574 +4603 4 35.716 17.1791 39.8253 -12.5236 -4.37947 -14.4862 +4604 4 36.6569 16.9265 40.9504 1.18426 15.263 2.6664 +4605 6 26.2972 0.194896 33.0957 0.945324 -1.75644 -10.1569 +4606 4 26.0926 0.771392 33.8475 -8.68516 2.0119 1.91424 +4607 4 25.4691 41.6865 32.8295 -8.00507 -1.67316 12.192 +4608 6 5.19113 35.5773 31.6357 23.2413 -27.7984 27.0466 +4609 4 6.1476 35.7159 31.7435 -10.1506 4.22761 6.12862 +4610 4 4.96861 36.095 30.8978 -11.7512 22.2076 -38.0194 +4611 6 20.2191 22.0354 35.1304 9.30742 -6.19625 19.4235 +4612 4 19.9844 21.2003 34.7289 -5.16022 -6.81034 -3.33987 +4613 4 20.4782 21.7596 36.0473 -3.02096 9.85719 -25.9724 +4614 6 15.9251 36.5949 36.947 -9.13121 -30.7472 31.1466 +4615 4 16.4837 37.3712 37.0549 6.13876 -3.03661 -2.05614 +4616 4 16.031 36.0658 37.8159 -5.1453 16.1721 -39.9007 +4617 6 30.9484 22.4015 3.56131 11.993 -60.8988 -15.4947 +4618 4 31.1008 22.6958 4.44557 1.55935 5.74187 27.4751 +4619 4 31.2551 21.4217 3.58407 -13.4398 43.4536 -6.61432 +4620 6 47.0429 8.40936 14.2086 -4.42011 -15.6298 -34.0486 +4621 4 46.2603 8.29509 13.606 17.325 5.05196 18.7602 +4622 4 47.7698 7.89697 13.7682 -18.8904 11.0332 12.0247 +4623 6 34.1011 18.6159 3.148 0.361877 23.965 35.4915 +4624 4 34.6363 18.3397 3.89922 -0.845538 -0.743075 -4.07575 +4625 4 34.3812 18.1265 2.40098 2.04544 -17.9565 -29.3984 +4626 6 26.7996 25.3961 12.3408 -30.8906 -54.2954 26.5725 +4627 4 27.3117 26.1608 12.4557 20.536 44.4803 3.39785 +4628 4 26.6414 25.0259 13.2528 6.28377 9.49183 -30.6151 +4629 6 22.6108 25.7845 30.8845 17.3255 -0.303924 3.7754 +4630 4 23.4288 25.6954 31.4132 -11.344 -1.13015 -1.03332 +4631 4 22.2314 24.9052 30.7722 1.09512 -5.6623 7.4309 +4632 6 23.6311 9.76276 35.7585 -2.90797 -4.19552 -4.78319 +4633 4 22.8314 10.2832 35.6581 -5.74139 5.63622 4.02691 +4634 4 23.3139 8.86685 35.4998 11.2809 19.0625 6.63709 +4635 6 10.4076 36.7742 9.64242 -28.436 -9.9846 9.32351 +4636 4 9.50067 36.3875 9.59353 19.7531 11.7612 -0.53903 +4637 4 10.7226 36.8301 8.7426 3.69205 5.92187 -13.8772 +4638 6 4.00038 32.4265 25.8669 22.0714 10.4661 11.4497 +4639 4 4.38844 32.9375 25.1422 -1.34031 3.54398 1.69886 +4640 4 3.2706 31.9516 25.4996 -17.8371 -17.4963 -10.4987 +4641 6 29.085 26.0296 18.6527 19.273 -47.5776 11.2122 +4642 4 28.2115 26.0231 19.0264 -21.1607 3.13806 -0.423844 +4643 4 29.4632 25.1291 18.9323 -7.10954 42.4601 -14.5827 +4644 6 15.3089 1.3255 27.9792 -24.1234 20.5069 -17.5654 +4645 4 15.0496 0.974163 27.1169 2.04641 -4.01433 11.5068 +4646 4 14.7355 2.12388 28.0804 19.9995 -12.8223 4.08523 +4647 6 48.6106 2.88816 22.9655 -1.26722 3.55247 -0.201848 +4648 4 48.4165 2.02818 22.6182 -14.5439 -12.5884 3.03438 +4649 4 49.5001 2.98572 22.6432 10.4652 10.9023 -5.33271 +4650 6 53.0075 0.36099 19.7296 11.424 -8.43987 -8.95848 +4651 4 52.5965 41.9022 20.5162 -3.41206 4.78179 6.33318 +4652 4 52.3731 0.223553 19.0136 -6.83989 5.16364 0.289704 +4653 6 1.41074 17.5036 17.9462 -15.7932 -16.9445 -5.36496 +4654 4 1.29993 17.3585 17.0019 -2.92928 12.5396 -5.88676 +4655 4 1.38271 16.6004 18.2823 6.65411 -3.00458 14.0519 +4656 6 37.9084 19.0323 37.6056 -38.9323 8.68785 -13.5971 +4657 4 36.9858 18.7285 37.7384 11.3307 8.89304 -0.372118 +4658 4 38.4207 18.4342 38.1195 19.3518 -17.7067 16.118 +4659 6 26.9813 30.3571 38.0896 -0.527767 18.5171 -30.3811 +4660 4 26.1212 30.285 37.6565 1.23907 -9.17466 9.80696 +4661 4 27.2764 31.2069 37.701 2.1524 -13.2267 12.8694 +4662 6 20.0955 18.5722 3.03696 10.9017 21.9571 9.92937 +4663 4 20.0263 17.806 3.59422 -10.4522 -23.2015 2.62566 +4664 4 20.8322 19.0363 3.46766 -4.52129 0.073665 -16.3651 +4665 6 35.0841 6.94694 4.08385 8.40312 -14.6319 10.4582 +4666 4 35.6826 7.16069 3.3578 -1.64356 4.34706 -6.00978 +4667 4 34.2613 7.42764 3.99145 -7.61312 4.93718 -6.31016 +4668 6 22.2176 37.0878 31.2599 -35.8324 13.882 69.7054 +4669 4 22.1593 36.8558 30.3798 -4.04212 -13.8909 -61.3413 +4670 4 21.2552 37.1952 31.5589 44.4461 1.84169 -14.4682 +4671 6 12.3904 22.3711 41.8265 33.9103 21.3816 -17.5574 +4672 4 13.0623 23.0096 41.4404 -31.3175 -17.017 24.3472 +4673 4 11.7392 22.2302 41.1411 -5.71588 1.3909 -0.895108 +4674 6 43.2333 30.3145 23.1566 26.412 30.0652 1.94466 +4675 4 44.1443 29.9954 22.911 -23.9673 11.2944 4.28313 +4676 4 43.3588 31.2906 23.3811 -4.98348 -33.6726 -4.24118 +4677 6 16.5316 8.07904 16.6592 -13.1305 -2.58289 1.30551 +4678 4 16.426 8.46358 15.7881 -7.07274 -4.02537 -8.52635 +4679 4 17.4421 8.27811 16.8595 11.8389 2.77268 11.6749 +4680 6 10.0527 8.64979 31.7837 -8.97334 17.7557 -57.5223 +4681 4 10.1312 7.90747 32.3291 5.58005 -27.1767 37.8097 +4682 4 10.1183 9.47003 32.2578 1.92783 9.29621 23.4619 +4683 6 10.1389 6.52097 25.6279 25.2027 -9.57639 0.964906 +4684 4 9.42987 6.19895 26.1639 -19.2857 -8.54063 7.31181 +4685 4 9.7626 7.17299 25.0306 4.07146 -2.80849 4.96109 +4686 6 49.8614 7.23714 25.5252 -17.9172 7.62946 -5.56104 +4687 4 50.0467 6.31121 25.4422 2.69032 -18.6529 -6.42341 +4688 4 50.6907 7.63095 25.75 18.9978 12.6416 8.6826 +4689 6 18.4677 37.5766 33.9365 -27.5019 7.45217 1.11424 +4690 4 17.6855 38.1606 34.0956 24.1544 -3.52274 -4.16364 +4691 4 18.0518 36.7105 34.0373 4.53854 -5.63623 -1.47673 +4692 6 32.1991 34.7999 39.2511 37.7035 -28.7103 22.0041 +4693 4 32.3976 34.2973 40.087 0.14143 15.1618 -21.7552 +4694 4 31.3182 35.0784 39.3573 -42.2601 10.9481 4.26487 +4695 6 49.5371 23.9083 4.45427 26.1113 1.30104 -36.4507 +4696 4 49.7626 23.2251 5.06121 8.22711 -23.3511 16.8473 +4697 4 48.7895 24.3154 4.8182 -37.5883 23.1909 21.4935 +4698 6 6.05615 24.4755 33.9372 -3.62864 21.1406 1.2609 +4699 4 6.78781 23.8493 33.8811 -5.98028 -5.90455 -1.42734 +4700 4 5.44033 24.2071 34.6424 10.5748 -4.32926 -7.84557 +4701 6 1.71417 22.9797 24.1919 12.9465 25.751 -13.942 +4702 4 1.74027 23.9063 23.8744 -7.21984 -9.04225 7.93975 +4703 4 0.785802 22.7901 24.3299 -10.4675 -5.82386 8.34916 +4704 6 12.4544 16.5695 32.338 -33.1179 2.9171 31.5337 +4705 4 13.1434 15.995 32.5512 52.391 -27.2499 -12.3732 +4706 4 11.9701 16.4097 33.1768 -13.251 25.8897 -21.4653 +4707 6 21.3776 37.3784 27.9508 -6.73969 12.2577 23.3137 +4708 4 21.2203 37.3231 27.0262 1.16773 -1.52428 -34.5533 +4709 4 20.718 38.0458 28.2038 6.71566 -1.73666 8.03222 +4710 6 27.2299 40.8388 28.8031 2.48401 0.937021 1.60569 +4711 4 26.5367 41.5089 28.9565 6.65702 -12.2841 2.86921 +4712 4 27.4065 40.3185 29.6035 -12.9999 8.55112 -0.224288 +4713 6 0.993205 21.7261 13.5372 -53.3037 2.48171 -36.3839 +4714 4 1.86429 21.8093 13.8237 52.7771 -6.56786 29.3883 +4715 4 0.417346 21.4203 14.2472 8.63216 3.11646 10.526 +4716 6 22.3067 2.58146 8.73662 29.448 -13.2509 35.6107 +4717 4 22.9722 3.05705 8.24165 5.16658 9.50374 -8.2335 +4718 4 21.5154 2.5876 8.23764 -24.8297 4.23497 -21.3736 +4719 6 29.9953 17.8456 8.24313 -2.433 8.62767 -9.90081 +4720 4 29.054 17.6713 8.30654 -5.44558 -4.70631 2.21427 +4721 4 30.3746 17.4275 9.01982 5.69521 -3.15286 8.62416 +4722 6 3.62819 37.7118 25.7099 -17.1271 -24.8271 -10.3244 +4723 4 4.40422 37.1524 25.7956 9.9921 4.76654 4.66524 +4724 4 2.941 37.0477 25.4485 4.12723 25.8155 6.09629 +4725 6 26.809 27.648 36.3589 -37.7802 -17.2474 29.8166 +4726 4 26.8014 28.1831 35.5758 -1.13827 16.217 -13.4241 +4727 4 25.8725 27.5642 36.7259 28.3017 7.35189 -21.1707 +4728 6 13.3559 25.3099 38.116 1.93465 -14.8526 16.0582 +4729 4 13.2959 24.3789 38.4372 3.98877 20.6101 -4.99041 +4730 4 14.1146 25.694 38.605 -5.66874 -3.07699 -9.11419 +4731 6 49.7048 27.2599 6.72622 -1.43928 22.3256 -10.7839 +4732 4 49.6686 26.3369 6.45132 -5.99645 4.70457 -4.8273 +4733 4 49.2845 27.8697 6.04945 8.54794 -27.7312 19.0533 +4734 6 39.7449 11.5776 10.1987 6.84991 -8.95817 -1.04181 +4735 4 40.3059 10.8428 9.86803 -8.86198 19.4731 1.33094 +4736 4 39.0907 11.7833 9.50723 6.52335 -1.56097 1.75374 +4737 6 17.4857 24.9907 35.5559 -11.6728 -0.232318 -1.23817 +4738 4 17.2359 24.7743 34.6481 -9.71541 0.96097 3.2925 +4739 4 18.4326 24.9281 35.5495 18.729 -4.76527 0.24637 +4740 6 45.0886 34.9858 31.8393 -13.7853 -2.59791 -12.3576 +4741 4 44.2542 35.4282 32.0247 4.31579 11.0194 10.5125 +4742 4 44.8031 34.4855 31.0733 13.3341 -13.9746 -4.20839 +4743 6 30.2109 9.89077 31.3202 8.39813 20.0527 10.0978 +4744 4 30.4343 10.7522 30.9233 -1.69236 -11.2354 5.34707 +4745 4 30.0976 10.0887 32.2697 2.61193 -8.5831 -6.90929 +4746 6 32.3748 9.22464 6.61109 37.8815 -39.2378 -50.8405 +4747 4 32.2118 8.68084 5.76454 4.57858 20.451 35.1159 +4748 4 31.5433 9.4233 6.96427 -45.6188 15.529 19.6617 +4749 6 9.26845 24.9782 35.9229 1.19564 -9.02769 -15.4958 +4750 4 8.9564 25.4582 35.1216 5.49795 -4.99978 19.1154 +4751 4 9.87718 25.5584 36.4061 -8.42028 -2.10732 -11.5846 +4752 6 40.3335 1.48296 18.8902 20.9136 0.652934 -58.3414 +4753 4 39.6207 1.94237 19.2768 -32.228 11.5513 31.9135 +4754 4 40.836 0.952532 19.4949 5.43911 -12.9068 21.333 +4755 6 5.27733 10.6166 30.4293 -4.37857 29.6514 35.8012 +4756 4 5.00531 11.4476 30.0112 -0.880507 -1.63534 -8.13264 +4757 4 5.35863 10.9185 31.3957 -0.759826 -20.4729 -25.7258 +4758 6 25.6655 11.6994 25.6535 -15.8411 -39.3949 6.40341 +4759 4 25.8392 12.448 26.1908 9.94197 23.9877 11.5846 +4760 4 25.8146 10.9427 26.2759 4.01869 23.17 -23.7809 +4761 6 21.9208 20.0736 29.783 -0.661059 -23.1285 25.9828 +4762 4 22.5528 19.9674 30.5279 -9.0028 12.6586 -11.845 +4763 4 21.4796 19.2024 29.7633 3.30396 8.80601 -15.8778 +4764 6 10.0031 19.9894 34.5062 10.0701 -18.9504 -1.84201 +4765 4 9.43917 20.4787 35.093 -9.85162 7.82768 6.06887 +4766 4 9.97528 19.0642 34.823 3.96148 11.1077 -9.79004 +4767 6 24.6395 10.3611 12.2013 10.4056 19.7725 40.7349 +4768 4 24.7062 9.53294 12.699 -2.91134 1.50973 -12.3578 +4769 4 25.0089 11.0108 12.8733 -15.5791 -20.8054 -25.2752 +4770 6 50.4386 28.2959 11.551 52.3964 -11.4141 -41.8896 +4771 4 51.2944 28.7096 11.1811 -37.3824 -15.4271 20.8858 +4772 4 50.1484 28.8694 12.238 -9.02874 19.1251 18.783 +4773 6 13.9255 27.6321 25.0575 -30.7043 9.27758 -16.9407 +4774 4 13.4685 27.961 25.8505 6.53671 1.50814 -8.33226 +4775 4 13.405 28.0084 24.2853 19.6442 -13.6277 24.9436 +4776 6 46.1675 18.6723 40.4127 -24.7255 0.52235 -5.51451 +4777 4 45.2163 18.6287 40.1471 17.8616 -3.70574 0.193046 +4778 4 46.2526 19.5549 40.792 -2.63441 -2.56699 -8.45512 +4779 6 32.4875 14.1744 27.1342 -20.1773 -0.115465 -0.458595 +4780 4 31.894 13.6021 27.6676 10.0212 10.5514 -7.27374 +4781 4 32.1329 15.0809 27.2203 4.74838 -8.22403 2.71507 +4782 6 14.0641 36.351 13.3878 -9.69625 43.6715 -7.48797 +4783 4 14.0645 37.3444 13.3555 12.262 -25.9465 20.9036 +4784 4 13.2835 36.2347 12.8457 -5.28255 -22.0231 -7.64651 +4785 6 1.89477 36.5899 21.9857 -12.7075 -7.68583 0.53673 +4786 4 1.75133 36.5712 22.9388 2.01013 -3.06644 8.01032 +4787 4 2.81569 36.8315 21.8421 3.36212 -1.19737 0.805445 +4788 6 25.2943 31.8607 39.7417 -2.48011 0.614033 34.0265 +4789 4 24.999 32.7283 39.4716 -5.73903 6.77443 -6.35095 +4790 4 25.461 31.9431 40.7124 0.191009 -4.33082 -23.8473 +4791 6 6.4797 22.0186 1.29894 -12.0535 -14.7769 -6.17691 +4792 4 5.53353 21.8063 1.36197 11.0348 5.26157 5.70773 +4793 4 6.5732 22.8347 0.80957 1.58971 11.8894 0.78955 +4794 6 27.6266 25.0275 4.69979 7.76412 30.8855 29.066 +4795 4 28.5017 25.4862 4.66738 -16.9061 -15.4428 -5.02391 +4796 4 27.2115 25.3905 5.52919 8.95609 -10.8934 -21.2922 +4797 6 21.6474 30.9429 41.2213 -14.674 16.9935 -31.5335 +4798 4 21.3077 30.3434 41.8509 -10.7705 -24.5884 29.0962 +4799 4 20.9035 30.9616 40.5667 22.5963 5.39714 5.21952 +4800 6 32.3503 18.8691 12.7728 -7.52429 -0.383917 -18.241 +4801 4 31.3918 18.9773 12.8161 6.27066 1.36054 6.85895 +4802 4 32.4619 18.5656 11.8564 12.6246 0.663961 8.91714 +4803 6 35.6352 19.4593 21.1461 -10.1734 29.4522 17.7801 +4804 4 35.3511 18.62 21.5049 -2.07097 -11.6796 -4.30053 +4805 4 34.9906 20.1214 21.5255 16.9121 -20.2959 -15.2058 +4806 6 27.6974 17.9478 34.0105 3.72497 22.7808 11.4532 +4807 4 28.1244 18.3695 33.2449 -3.6365 -3.33971 3.70746 +4808 4 28.0134 18.5196 34.7467 -3.33496 -14.4526 -11.1074 +4809 6 34.1722 39.0415 14.8025 -0.588556 -5.09353 50.87 +4810 4 33.8492 38.3378 14.2426 -9.69809 -4.78927 -2.35124 +4811 4 33.6075 39.0103 15.6476 14.9636 10.6202 -38.8415 +4812 6 28.5063 3.47722 33.8826 -13.8698 -21.2799 4.06498 +4813 4 27.871 4.20321 33.9085 6.20243 8.28698 -1.91661 +4814 4 29.4175 3.76621 33.9059 10.9167 16.0273 -3.84391 +4815 6 34.9231 32.1486 6.55347 -48.5451 -22.9266 3.43697 +4816 4 33.9921 31.9748 6.9467 49.872 11.9331 -17.2337 +4817 4 35.5478 32.1135 7.28146 1.17984 3.66225 6.53991 +4818 6 31.8923 6.87344 23.517 2.73099 13.3553 4.48118 +4819 4 32.4005 6.72509 22.7097 -0.163961 -9.68163 3.8586 +4820 4 32.2042 7.75277 23.812 -2.19309 -5.80853 -1.60196 +4821 6 18.8495 1.74691 0.846251 -10.8424 6.73855 -33.2301 +4822 4 18.128 2.12906 0.287715 7.30697 -5.37966 19.0723 +4823 4 19.1812 2.42034 1.43504 -3.90896 9.02122 12.2654 +4824 6 27.0029 18.9235 11.8738 61.7268 20.0146 -35.0636 +4825 4 27.2277 19.7644 11.4142 7.64396 -16.2258 9.71345 +4826 4 26.1059 19.0334 11.9849 -72.3018 -1.47246 20.779 +4827 6 43.8315 11.1413 18.4425 12.0955 7.77381 31.2403 +4828 4 43.582 10.9955 17.5403 1.6883 -14.8273 -19.2234 +4829 4 44.4878 10.475 18.7348 -4.89818 7.49251 -15.5557 +4830 6 33.4942 40.5585 37.6724 7.87983 -3.11064 16.6213 +4831 4 33.9456 40.2455 38.4765 5.57637 6.44045 -9.71494 +4832 4 32.6057 40.2384 37.8499 -11.5443 1.61602 -9.31227 +4833 6 15.6218 26.7049 39.4143 -33.8245 -53.4627 11.7102 +4834 4 15.4245 26.9754 40.2985 -0.693124 5.44593 20.3253 +4835 4 16.1216 27.3809 39.0562 36.6223 43.7441 -31.7418 +4836 6 4.38199 13.876 40.8778 6.07973 -11.0772 -3.70535 +4837 4 5.33347 13.6897 41.0138 -14.6737 -0.272428 -1.39073 +4838 4 4.02273 13.2235 40.2449 7.64869 11.7946 8.98025 +4839 6 20.1779 10.396 38.2135 -21.4206 4.43784 1.78325 +4840 4 20.3564 10.9148 37.4134 10.9013 -11.3706 0.559506 +4841 4 20.991 10.2443 38.6984 6.99273 1.77474 -1.94206 +4842 6 15.1578 19.2491 23.8705 6.70925 0.197906 -4.49513 +4843 4 15.3523 20.1614 24.134 -1.79925 -4.44488 8.10361 +4844 4 15.0598 19.3463 22.9079 -1.20619 -5.61783 14.9214 +4845 6 47.881 28.6148 15.8048 16.8356 22.7469 11.8397 +4846 4 48.0602 27.74 15.4965 -2.52866 -23.0751 -5.40804 +4847 4 48.6281 28.8091 16.402 -10.5906 -5.01786 -6.93826 +4848 6 29.925 30.905 18.9707 11.7406 3.33263 -1.10353 +4849 4 29.0879 30.4807 18.764 -8.84985 -7.33813 -1.92291 +4850 4 29.807 31.8375 18.7873 -6.04184 4.11832 2.37084 +4851 6 11.9324 35.8064 28.512 -27.4265 24.0258 -21.7564 +4852 4 12.5706 36.1347 29.1334 15.2736 -4.81493 21.8335 +4853 4 12.2236 34.9831 28.145 8.79196 -20.6768 -0.490374 +4854 6 29.967 37.8624 25.4885 4.59009 -4.14727 -0.313094 +4855 4 30.2605 37.0012 25.8228 -4.78695 -0.224547 -14.1967 +4856 4 30.4431 38.4647 26.0537 0.190265 15.5785 7.27405 +4857 6 52.6385 28.1101 32.2696 27.4129 -14.0906 14.429 +4858 4 52.1837 28.8064 31.8018 1.35463 13.918 -3.63194 +4859 4 53.5572 28.4115 32.4361 -8.8806 -0.527566 -10.0859 +4860 6 37.0194 40.0856 11.9811 12.8522 -14.0915 -8.99985 +4861 4 36.2698 40.6335 12.1547 -20.3135 9.86443 5.11387 +4862 4 37.3206 39.8255 12.8594 7.06858 1.59634 4.17732 +4863 6 16.6823 16.7862 36.5016 -40.0159 24.4695 -22.7659 +4864 4 15.9639 17.4464 36.7433 30.1481 -22.6997 -3.51596 +4865 4 16.709 16.8774 35.5181 2.88256 -1.64708 20.873 +4866 6 28.0056 4.17661 38.8341 -15.1907 4.44859 15.1459 +4867 4 28.8664 4.34511 39.2253 10.7528 -1.70638 -4.98709 +4868 4 28.1362 3.72531 37.9969 -2.54795 -6.06729 -7.91519 +4869 6 28.9121 0.2613 17.7196 11.2429 43.6022 -6.13696 +4870 4 28.206 0.913023 17.5432 1.57334 -10.0134 0.986336 +4871 4 28.5175 41.3357 17.883 -22.7122 -29.353 3.51833 +4872 6 22.9275 20.1119 26.272 10.3141 -17.1908 1.54721 +4873 4 23.597 20.0083 26.9758 -6.33812 5.26805 -6.32666 +4874 4 22.343 20.8217 26.5441 4.5912 8.26641 6.04785 +4875 6 49.4104 29.8887 13.4211 -27.0365 40.5227 7.20695 +4876 4 49.0994 30.824 13.2506 14.963 -27.7355 -0.582388 +4877 4 48.6865 29.5209 13.9525 8.18699 -4.12202 2.86767 +4878 6 2.45827 24.8307 7.29137 -22.8365 1.45709 37.207 +4879 4 2.32025 24.5445 8.23446 11.0976 11.5137 -22.649 +4880 4 1.77037 25.516 7.1857 7.09177 -11.7652 -6.70138 +4881 6 30.3948 26.4611 14.3404 -21.8067 20.3233 2.80707 +4882 4 31.1122 26.3224 14.9982 -12.4575 10.0222 -1.69757 +4883 4 29.8137 27.2743 14.5309 34.7851 -33.9666 2.2264 +4884 6 27.0321 32.5068 3.14827 -14.3662 17.1598 1.60641 +4885 4 26.4039 33.1156 3.62616 22.1531 -16.0826 -13.2832 +4886 4 27.3831 31.9163 3.82559 -1.71579 -4.01879 3.19031 +4887 6 34.2634 14.7959 1.27313 2.99828 -7.05923 -10.0889 +4888 4 35.1835 14.4352 1.19997 -20.4533 4.23129 -4.55267 +4889 4 33.713 14.3258 0.588346 24.9828 8.52884 21.9593 +4890 6 30.022 8.54163 1.32868 -10.2939 -13.069 16.6852 +4891 4 30.0052 9.45247 1.0409 -5.08902 11.4157 2.73646 +4892 4 29.2496 8.43498 1.92915 15.9692 5.13326 -10.6744 +4893 6 42.5647 11.5185 27.7103 -4.68909 6.08661 -3.61857 +4894 4 42.216 12.3928 27.8946 9.09127 8.642 -2.18095 +4895 4 41.8714 10.9656 28.0604 -6.00702 -16.6262 4.78299 +4896 6 52.461 39.5492 17.8365 12.2605 -26.0754 -32.0817 +4897 4 51.7553 39.7908 18.3861 -39.7898 9.50592 28.6027 +4898 4 53.1226 40.1801 18.0155 30.5873 23.5517 5.0779 +4899 6 33.2136 4.91918 31.6183 -6.56942 36.6821 16.923 +4900 4 32.9061 5.86322 31.5606 3.78329 -26.1329 5.01225 +4901 4 32.8884 4.48208 30.835 -2.61462 -3.20134 -11.4125 +4902 6 6.2936 16 18.7476 -12.5252 7.31014 22.9936 +4903 4 5.79227 16.5246 19.4216 24.8679 -4.64947 -16.2991 +4904 4 5.64136 15.3462 18.514 -6.08951 -9.62478 -9.34051 +4905 6 8.52033 14.5365 24.6875 -9.84601 3.26611 -2.01077 +4906 4 9.36791 14.3624 25.0978 6.86066 0.30113 1.47813 +4907 4 8.18366 13.6846 24.3866 1.77672 -1.96336 3.84573 +4908 6 22.6911 10.1297 32.1351 -27.5214 -52.5729 10.3709 +4909 4 22.3884 10.9899 32.3649 2.47289 32.4289 -2.22619 +4910 4 23.5203 10.1223 31.6812 20.4751 21.0076 -14.9216 +4911 6 11.292 2.12704 14.679 -26.9964 -14.1635 0.457424 +4912 4 10.3004 2.01295 14.5746 25.662 7.6895 -7.09692 +4913 4 11.7079 2.38272 13.8392 -0.157448 -3.91762 -7.39795 +4914 6 44.9096 15.591 36.2717 33.6405 -1.91298 -30.8875 +4915 4 45.0764 15.4828 35.303 -3.33411 7.1012 27.4883 +4916 4 43.99 15.446 36.3379 -31.2371 -2.78707 10.2167 +4917 6 9.72465 19.0179 31.2227 19.6005 -24.8416 -16.8371 +4918 4 10.5897 19.4265 31.3159 1.30764 -1.40065 3.11778 +4919 4 9.11252 19.5759 31.653 -23.8989 17.913 16.8503 +4920 6 51.9714 7.58847 16.6881 21.0297 -20.8952 -55.8985 +4921 4 52.6598 6.90966 16.567 -10.1825 8.15334 22.1112 +4922 4 51.6538 7.5728 15.7392 -8.87714 21.5211 34.751 +4923 6 31.4317 34.7753 36.422 -0.942044 -9.40807 -31.2122 +4924 4 31.7249 34.7672 37.3268 6.30465 10.9632 14.3566 +4925 4 31.2441 35.6593 36.0754 6.17504 10.5044 11.3925 +4926 6 4.22663 15.0937 15.3657 -12.9272 -11.1361 22.285 +4927 4 4.10058 14.8824 16.3208 1.18356 5.05287 -17.269 +4928 4 5.17453 15.1773 15.2713 12.4851 5.61025 -4.39011 +4929 6 47.7531 20.6767 28.0224 11.2198 -3.02063 -12.9376 +4930 4 47.6925 19.771 27.6598 -2.10862 13.919 9.51432 +4931 4 48.3916 21.1163 27.4231 -12.1395 -0.81062 10.3277 +4932 6 15.815 1.15165 24.4078 -58.142 17.9603 -16.0616 +4933 4 15.2825 0.557615 24.9446 12.6892 -15.3828 1.22604 +4934 4 15.0545 1.63036 23.9524 41.7436 -8.72437 9.7488 +4935 6 34.5811 39.7067 40.0776 25.1973 35.6425 -42.1699 +4936 4 34.2041 40.3093 40.7031 -18.6223 -6.05265 24.4589 +4937 4 34.3171 38.8242 40.1905 -21.7766 -38.3424 16.3885 +4938 6 20.1959 32.1778 34.4064 -21.1308 28.8301 22.4919 +4939 4 19.7756 32.8897 35.0113 13.9702 -37.934 -23.8567 +4940 4 21.1121 32.1056 34.6926 -2.59197 2.17732 9.39736 +4941 6 19.2966 38.5284 11.8437 26.0429 16.0259 -0.414132 +4942 4 19.2747 37.5954 11.9891 -3.91225 -17.7096 3.53088 +4943 4 20.0654 38.8356 12.3915 -17.5462 -2.40166 -9.14392 +4944 6 6.53181 13.5016 26.8314 -26.032 48.4544 -13.2533 +4945 4 5.96734 14.0602 26.204 31.1233 -23.713 24.7575 +4946 4 6.50803 12.6321 26.4707 -0.853216 -24.803 -10.5103 +4947 6 23.5899 31.5666 33.3383 5.98922 -6.50638 -9.93577 +4948 4 23.0479 31.6137 34.1308 1.15429 -4.79335 1.92272 +4949 4 23.6428 30.629 33.0606 -7.31668 7.17491 0.194963 +4950 6 41.0566 31.9249 16.2102 56.5158 -30.8904 -22.4873 +4951 4 41.9283 32.0344 16.659 -25.525 5.07155 -0.752829 +4952 4 41.3339 31.2779 15.4895 -19.0587 21.5349 12.1439 +4953 6 31.7523 18.8667 19.3593 3.35741 25.414 0.712525 +4954 4 32.0759 19.7269 19.7383 -8.81617 -22.0304 -12.3923 +4955 4 31.2718 18.4298 20.0739 7.05067 -2.94537 3.38628 +4956 6 10.4941 4.11052 19.3414 6.42456 29.4713 -33.6332 +4957 4 9.72315 4.57262 18.9428 7.32966 -14.5804 7.11 +4958 4 11.2095 4.33965 18.6811 -15.5987 -11.1936 33.5314 +4959 6 1.36933 32.4682 19.2841 21.0988 -14.4161 24.2075 +4960 4 2.01529 31.7231 19.2122 -13.2253 9.85044 -10.2965 +4961 4 1.01532 32.721 18.4367 5.36339 -4.1954 -20.4987 +4962 6 42.8687 16.8583 24.9978 45.6636 -43.4462 -50.5941 +4963 4 42.5079 17.7172 24.9824 -17.3855 32.283 0.331695 +4964 4 43.4322 16.7911 24.1362 -30.0172 8.55702 44.8961 +4965 6 45.317 19.181 4.10785 3.8422 34.8536 -4.15721 +4966 4 46.019 19.8398 3.89275 -2.03222 -14.2005 10.5278 +4967 4 44.6424 19.7199 4.5744 3.59127 -10.0852 -3.22755 +4968 6 29.1417 19.8939 35.7514 6.11075 -32.58 -16.2332 +4969 4 28.6926 20.3067 36.4515 -23.9686 13.1333 31.3988 +4970 4 29.2427 20.5957 35.1143 7.28783 5.32225 -12.4577 +4971 6 31.9564 21.8498 19.6592 2.82401 14.2352 -0.350828 +4972 4 32.7548 21.9543 19.0677 -31.5105 -7.28354 24.2009 +4973 4 31.6217 22.7614 19.848 10.5207 -20.3739 -6.13763 +4974 6 39.1981 8.2717 18.8284 -32.9061 14.1933 0.428726 +4975 4 38.9624 7.35629 18.6463 1.07118 -6.83808 -1.96228 +4976 4 38.3348 8.76709 18.6863 31.0345 -14.9445 1.78619 +4977 6 33.2818 13.2775 41.2684 -13.2208 -33.3764 1.31987 +4978 4 32.393 13.5626 41.0006 -3.83673 2.91025 7.56978 +4979 4 33.1808 12.3338 41.5845 5.22215 22.8712 -2.04361 +4980 6 5.9413 29.5498 35.797 -32.456 -34.3071 -6.72563 +4981 4 6.35963 30.284 36.1739 22.861 33.0715 10.0739 +4982 4 6.49565 29.1835 35.1072 8.32337 2.91553 -5.44074 +4983 6 13.0321 34.2086 31.915 -24.835 -40.2345 36.8573 +4984 4 13.0272 33.4084 31.376 1.88868 -0.760633 -7.07942 +4985 4 12.5489 33.9041 32.737 18.271 18.5714 -18.1292 +4986 6 33.9591 21.7903 18.011 18.8454 -21.734 -8.71067 +4987 4 34.7458 21.1933 18.012 -16.5142 3.18134 2.17277 +4988 4 34.2934 22.6573 17.8484 16.983 20.6817 -10.003 +4989 6 35.9748 41.3385 18.1559 -11.3515 0.0380054 -35.3696 +4990 4 35.8093 41.5204 17.1769 9.12346 -12.4659 34.6458 +4991 4 36.6045 0.098617 18.3947 7.40652 10.177 5.52403 +4992 6 34.8515 37.6574 30.5934 11.7527 -35.7483 27.3047 +4993 4 35.1492 36.8608 30.1169 2.57906 15.2804 -10.7791 +4994 4 34.9371 37.33 31.5271 -8.43612 19.6249 -16.9201 +4995 6 26.002 34.4146 4.67279 -8.48904 3.78898 9.19231 +4996 4 25.4415 34.5852 5.42871 -16.9308 -4.98482 2.97274 +4997 4 26.7915 34.86 4.9592 18.7282 4.65341 -5.76761 +4998 6 19.0552 33.5605 1.32358 6.49267 31.5074 -37.6332 +4999 4 19.8139 33.1288 1.70335 8.38847 -12.1483 9.88993 +5000 4 19.4402 34.1326 0.589952 -11.7405 -21.1797 25.0755 +5001 6 25.2648 8.23393 8.59155 9.31521 -3.65292 19.8467 +5002 4 25.4875 8.13778 9.5404 -3.07709 1.08931 -10.3145 +5003 4 25.4314 9.16241 8.38927 -1.28134 -0.00667841 -6.07783 +5004 6 12.8479 19.6935 13.0483 24.3757 5.37981 -4.8091 +5005 4 11.9603 19.9957 12.9501 -28.6845 1.86907 1.18076 +5006 4 13.3523 20.516 12.8959 -4.89806 -16.374 -0.906345 +5007 6 53.3502 11.4299 5.80806 17.1624 -7.42289 17.7098 +5008 4 53.8461 12.0471 6.36061 9.49207 -4.93163 0.0376 +5009 4 52.6392 11.9481 5.49246 -25.6427 10.4986 -14.7278 +5010 6 9.84876 16.0411 31.2026 18.9205 20.8399 7.27663 +5011 4 9.06508 15.7062 30.7868 -18.8641 -2.54228 -13.3824 +5012 4 9.84527 17.0253 31.1624 -7.05614 -14.0763 0.861631 +5013 6 25.427 20.2931 3.30062 11.4464 23.222 26.9187 +5014 4 25.5454 20.7694 4.15249 -9.33169 -17.4988 -10.5652 +5015 4 25.6323 21.0333 2.7154 -3.32412 -15.1122 -12.6987 +5016 6 20.7611 8.20749 15.6389 12.285 -44.7943 -30.6071 +5017 4 20.4521 8.55687 16.4556 -20.4937 3.03897 24.5457 +5018 4 20.4185 7.27697 15.5079 3.31214 29.403 13.2982 +5019 6 37.6491 8.60321 9.97383 13.4411 2.14626 39.4708 +5020 4 37.9762 7.71523 10.2023 -7.3296 7.95364 -3.74733 +5021 4 37.281 8.55077 9.10696 -2.37522 -5.79058 -16.8845 +5022 6 50.6587 4.51935 24.2622 -13.5896 -19.0591 8.29097 +5023 4 49.9232 3.87067 24.2726 8.09814 12.5004 -4.89174 +5024 4 51.4381 3.99879 24.4754 4.23299 2.4676 7.18675 +5025 6 20.1738 24.8175 34.9087 -20.6162 39.8894 -22.5586 +5026 4 19.8889 25.4664 34.1955 11.6566 -19.5752 19.2833 +5027 4 20.4138 24.0094 34.4666 -0.241841 -16.354 -5.00311 +5028 6 30.5812 22.5243 11.2258 -36.8716 21.596 38.6978 +5029 4 31.1688 21.9929 10.7494 35.9784 -15.9007 -22.5785 +5030 4 31.0799 23.2498 11.6175 0.71333 3.79074 -7.65826 +5031 6 17.3246 40.781 8.03002 -31.7256 21.6985 11.3561 +5032 4 17.3609 40.073 8.69249 8.70624 -3.14378 -12.3263 +5033 4 18.1517 40.9293 7.58873 21.0517 -16.9909 -7.06703 +5034 6 23.9551 41.0422 26.0635 49.9815 4.82526 35.6353 +5035 4 24.3667 40.5978 25.3173 -4.54613 -3.84774 -13.2149 +5036 4 23.0402 41.1884 25.9461 -38.539 -4.36769 -14.447 +5037 6 9.79432 25.5848 27.2203 6.65484 -20.1236 -27.319 +5038 4 10.0774 24.9678 26.4912 -4.54744 21.2611 22.5851 +5039 4 10.2742 25.3181 28.0139 -2.97183 -5.43805 2.20583 +5040 6 35.2559 29.8148 24.7567 4.66903 26.9266 -5.93859 +5041 4 34.3843 29.755 24.359 -8.51564 -12.4096 -2.57191 +5042 4 35.4992 30.7322 24.5163 3.09853 -9.53322 8.65044 +5043 6 2.14554 4.24448 10.5593 -22.2482 14.7122 10.1934 +5044 4 1.71214 4.34677 11.4486 21.0071 -10.277 -13.7719 +5045 4 1.55235 4.73342 9.96914 3.10164 -3.012 2.95666 +5046 6 43.1737 3.93442 23.504 -19.8173 -22.9925 0.828755 +5047 4 43.8868 4.03822 22.8829 13.7397 8.75634 -8.56433 +5048 4 42.5624 3.30318 23.0634 7.12322 11.7882 3.68849 +5049 6 18.8936 22.6308 2.43475 37.4693 -11.6119 5.39147 +5050 4 19.8359 22.2985 2.41568 -31.8063 3.38645 -2.45846 +5051 4 18.7431 22.7947 3.37318 -4.67781 1.83629 -1.28906 +5052 6 20.5039 18.9394 41.5502 -45.0653 -1.00263 50.2155 +5053 4 20.0478 18.6838 0.506021 30.3651 -1.16827 -32.2456 +5054 4 19.9073 19.6506 41.2865 12.7012 -1.26976 -15.3796 +5055 6 26.407 7.54687 29.1121 1.4357 2.47637 1.41449 +5056 4 25.6724 7.10479 28.6297 19.9382 8.96422 9.98625 +5057 4 27.0918 7.77745 28.4582 -11.2115 -7.41118 6.83701 +5058 6 25.6474 35.5684 33.7551 28.3954 -27.4775 -24.9773 +5059 4 26.3573 36.1942 33.5448 -9.56627 7.56335 10.8035 +5060 4 25.9974 34.7724 33.2466 -29.6941 19.0168 23.1671 +5061 6 24.829 0.49304 8.41898 49.9168 25.8876 59 +5062 4 25.5758 0.370102 9.1289 -47.1903 5.46774 -40.7742 +5063 4 24.7798 41.5674 8.0141 -4.73142 -31.3088 -22.2887 +5064 6 17.0191 17.3177 3.44507 -46.3903 19.7373 51.2207 +5065 4 16.2469 17.9517 3.64762 33.8447 -23.651 -21.8207 +5066 4 17.1185 16.9245 4.35427 5.98982 5.76213 -27.3591 +5067 6 40.1787 32.0965 19.3495 -2.04197 44.459 1.39821 +5068 4 39.7315 31.3261 19.6693 2.08081 -28.8107 0.337304 +5069 4 40.9568 31.869 18.8472 6.84111 -19.9226 -1.15348 +5070 6 23.382 26.6945 6.30636 26.5913 52.1271 15.5788 +5071 4 24.0556 27.4456 6.44648 -17.1373 -33.2326 -1.34025 +5072 4 22.7142 27.1153 5.75328 -6.08389 -4.52619 -7.61988 +5073 6 28.6524 28.5085 1.41248 40.8971 -13.4399 -11.1281 +5074 4 28.8916 29.4207 1.30452 -22.1266 20.7664 -4.28256 +5075 4 29.5558 28.1704 1.18501 -32.1523 -8.03877 13.3744 +5076 6 12.0456 6.33448 14.0345 -15.8903 -34.4 -29.7535 +5077 4 11.2902 6.05291 13.4483 16.0844 18.9407 21.6686 +5078 4 12.7823 5.99392 13.4906 5.33453 16.7776 14.1371 +5079 6 20.1258 33.7078 32.0959 -18.1893 1.56867 -4.93457 +5080 4 20.1945 33.0222 32.7471 -6.29187 -8.74149 18.477 +5081 4 21.0272 33.8529 31.8657 20.6776 7.89431 -10.0095 +5082 6 12.0665 33.3691 34.5458 -17.2285 -56.0193 -22.1145 +5083 4 11.5086 33.8793 35.1106 -7.76206 16.4549 16.9315 +5084 4 11.5605 32.4987 34.4127 27.4292 33.0374 0.608769 +5085 6 6.00658 22.2666 25.0532 -19.3255 -5.39958 94.237 +5086 4 5.834 22.4197 24.1868 -9.01045 11.6196 -89.8037 +5087 4 5.17345 22.6031 25.4913 31.6285 -9.76338 -3.83253 +5088 6 28.8848 9.49767 11.035 16.7623 9.63116 22.4077 +5089 4 29.0495 10.2086 11.6768 10.1151 -22.3542 -11.392 +5090 4 28.083 9.83925 10.6889 -25.6685 -5.48517 -25.0151 +5091 6 25.9808 31.1499 24.8669 6.22835 -24.9986 7.12483 +5092 4 26.2942 31.9621 24.5011 4.31737 18.7644 -10.9339 +5093 4 26.6597 30.4768 24.6157 -18.0541 8.02771 8.13926 +5094 6 17.4051 22.6403 26.9653 -7.75883 36.9734 2.0054 +5095 4 17.2144 23.5004 27.4753 3.96627 -41.4428 -18.3441 +5096 4 17.5261 21.9375 27.6083 1.93016 -8.19761 6.25563 +5097 6 30.9714 17.6252 1.64088 21.0154 14.9482 37.3685 +5098 4 30.2059 17.6112 1.0839 -20.4324 5.80492 -14.3468 +5099 4 30.9516 18.4373 2.23396 3.22156 -25.7853 -22.8165 +5100 6 35.2764 9.72503 11.2414 -18.3895 -2.76749 -51.624 +5101 4 34.6551 9.56245 10.4589 20.7383 2.80865 37.1903 +5102 4 36.1302 9.43155 10.8742 2.68762 -2.05229 10.7544 +5103 6 12.0172 10.802 4.27563 -38.9121 -6.07101 -4.90761 +5104 4 11.4313 10.6374 5.04504 13.8247 1.49432 -7.40831 +5105 4 11.4074 10.5604 3.53263 22.811 5.33779 9.30002 +5106 6 52.9577 23.1313 7.67787 -9.3269 3.09364 -7.79077 +5107 4 53.8153 23.0871 7.22609 1.51949 2.98805 -1.25247 +5108 4 52.6879 24.0607 7.78743 10.5919 -6.87524 0.0783357 +5109 6 27.3762 5.80009 23.1013 37.771 37.8703 25.2466 +5110 4 28.2178 5.56094 23.5856 -32.2451 -1.57897 -13.9899 +5111 4 27.4704 6.79781 23.0764 -15.1432 -38.3322 -6.34326 +5112 6 22.7771 37.7063 15.5287 -6.89324 -10.2053 44.7861 +5113 4 22.8198 37.7465 14.5962 3.81902 5.91484 -35.4551 +5114 4 23.2903 36.9427 15.8415 -1.83068 2.7653 -4.67104 +5115 6 30.583 30.1381 39.7472 11.9278 5.78959 4.89923 +5116 4 30.1399 29.6129 39.0656 -4.27402 4.25284 -2.63349 +5117 4 30.6547 31.067 39.4612 -8.3831 -13.7724 -7.9353 +5118 6 26.5154 14.8633 29.9609 11.0831 -12.5589 -33.9006 +5119 4 25.6935 15.2477 30.2118 -18.1143 15.4408 19.147 +5120 4 27.1376 14.9035 30.6723 6.99544 5.71887 23.1856 +5121 6 9.52617 19.5446 37.4141 -27.8096 33.0225 -3.94279 +5122 4 8.56344 19.6819 37.5998 22.5694 -19.9005 4.13551 +5123 4 9.71087 20.3892 36.9619 8.68778 -16.8671 10.038 +5124 6 0.93064 14.8656 2.69338 -45.7679 -11.5139 71.6593 +5125 4 1.44105 15.217 2.01526 37.3122 25.2366 -40.5783 +5126 4 0.982855 15.4275 3.5214 11.2099 -15.0526 -29.9277 +5127 6 46.4291 27.1302 41.5927 44.8021 -5.11347 -18.4756 +5128 4 47.4269 27.1857 41.3316 -52.8753 -1.56841 10.8767 +5129 4 46.0453 26.5632 40.9031 3.09365 7.20255 7.14326 +5130 6 47.6703 23.0461 21.3817 14.1329 62.5249 18.4178 +5131 4 46.9615 23.2467 20.7836 -14.1781 -2.67912 -10.5965 +5132 4 47.8255 22.1376 21.4096 0.736735 -54.6337 -3.62162 +5133 6 39.861 22.2186 3.09273 14.3751 -13.6386 -17.8056 +5134 4 38.9812 22.2192 3.47284 -7.54245 -0.786418 6.90323 +5135 4 40.0217 21.2868 2.78929 -10.5756 29.8648 14.1337 +5136 6 14.9857 14.9315 33.4628 8.45923 30.4043 17.83 +5137 4 15.3946 15.8263 33.6275 -11.7248 -28.7506 -9.93609 +5138 4 14.5839 14.7058 34.318 1.67348 -1.86342 -8.89677 +5139 6 27.3225 11.4951 31.9326 -53.5602 -46.3542 13.457 +5140 4 26.8632 12.0627 32.5566 10.8872 8.4751 3.08438 +5141 4 28.1269 11.8297 31.6518 53.6341 36.944 -15.9306 +5142 6 36.7606 7.97817 7.63938 -5.6216 -14.483 -15.6739 +5143 4 35.961 7.43887 7.80711 8.78578 3.79539 -7.6162 +5144 4 37.414 7.37034 7.2323 -6.45073 3.96969 3.37374 +5145 6 49.4351 9.64395 18.2091 29.626 55.2849 10.866 +5146 4 50.1121 10.1978 17.7651 -9.80365 -29.4086 -13.348 +5147 4 49.2806 10.2909 18.9191 -22.4891 -21.6225 2.73598 +5148 6 27.0558 33.8708 10.7695 -35.2964 21.4972 9.63291 +5149 4 27.0077 33.3399 10.0051 13.5655 -23.8621 -34.587 +5150 4 26.1863 34.3133 10.6733 10.9844 1.63438 18.9088 +5151 6 11.1931 37.467 6.82672 4.88099 -16.6436 19.1561 +5152 4 10.8369 38.341 6.72067 -6.30082 13.8936 -5.38019 +5153 4 12.1372 37.6177 6.93955 5.33816 -5.06614 -4.03667 +5154 6 19.2682 19.4041 21.904 -23.2853 8.1035 46.9014 +5155 4 18.5523 19.4276 21.2977 -21.2798 -5.04156 -20.5384 +5156 4 20.0545 19.4439 21.4012 35.6905 -5.22778 -21.4405 +5157 6 54.5004 2.91828 22.5705 32.5661 -1.01917 48.733 +5158 4 54.2618 3.02388 21.6728 -2.16971 10.501 -40.9175 +5159 4 0.435524 3.25313 22.7695 -30.9494 -6.38648 -13.13 +5160 6 45.0599 10.868 24.2364 14.5135 -18.2796 4.13426 +5161 4 44.3635 11.4663 23.9664 0.226806 13.7258 12.1538 +5162 4 45.5813 11.1999 25.0017 -10.9868 0.331296 -15.4884 +5163 6 14.3917 34.4176 24.7766 -9.76404 -18.453 -6.38428 +5164 4 14.7761 35.2693 24.9957 4.99605 2.44674 1.2141 +5165 4 14.8449 34.0832 23.9904 0.575187 7.45256 -7.27956 +5166 6 50.5869 17.5623 4.30497 19.1488 -58.6727 24.3661 +5167 4 51.3501 17.8958 4.78847 0.670503 12.5806 -1.04554 +5168 4 50.1422 18.2474 3.88142 -19.7161 48.0777 -23.3625 +5169 6 14.9242 33.337 34.1076 -18.6172 33.5363 80.554 +5170 4 15.0808 32.9083 33.3321 11.226 -38.5345 -73.3592 +5171 4 14.0723 33.0217 34.4665 7.96171 10.4343 -9.42002 +5172 6 20.8631 33.5747 38.9135 21.2953 11.2024 -25.7312 +5173 4 20.865 34.0752 39.7143 -3.94121 7.45437 24.6588 +5174 4 20.36 32.7884 39.0656 -12.436 -21.6406 1.81461 +5175 6 7.7707 4.74963 26.7362 26.5342 -10.6541 19.1955 +5176 4 7.23261 4.91898 27.5026 -6.83786 10.9421 8.37469 +5177 4 7.15089 4.73593 26.0203 -3.95236 1.60233 -15.9617 +5178 6 9.2875 21.4887 22.2941 45.0197 -19.5209 20.7118 +5179 4 8.6739 21.9912 21.7696 -4.21454 15.1903 -23.2464 +5180 4 10.2572 21.6206 22.0058 -46.5259 5.6334 -2.177 +5181 6 20.5439 38.2154 8.85856 -11.8412 3.64647 49.7312 +5182 4 20.3505 38.5634 9.79035 9.75602 -4.66312 -40.2998 +5183 4 20.2844 37.2891 8.95048 10.2824 2.6457 -7.05014 +5184 6 30.1005 39.0839 30.7484 -12.1958 38.1552 23.9792 +5185 4 30.3724 39.9578 31.2326 -12.541 -45.9124 -25.2432 +5186 4 29.1103 39.003 30.8437 30.6219 6.07536 -1.13857 +5187 6 16.0462 22.036 24.5064 2.37861 -9.55962 -5.99251 +5188 4 16.6334 21.9741 23.7207 6.17482 7.89117 19.2285 +5189 4 16.5569 22.3155 25.2979 1.4399 -2.17025 -8.02685 +5190 6 5.74172 29.2061 14.4603 -14.7312 11.1013 -1.58992 +5191 4 6.41865 28.6839 14.8489 24.8954 -16.4528 0.429681 +5192 4 5.37542 29.618 15.2515 -13.4536 5.99623 -6.25212 +5193 6 28.0689 3.08071 25.2267 -3.20814 35.3244 14.901 +5194 4 28.6407 3.76435 24.8336 -2.36389 -14.401 -4.10269 +5195 4 27.6795 3.6106 25.9691 7.41152 -23.0621 -10.2478 +5196 6 45.9381 29.3111 31.4283 -35.5447 25.9568 9.82539 +5197 4 45.677 28.707 30.7493 2.31008 -18.1922 -21.3643 +5198 4 45.1265 29.9079 31.4744 34.4717 -15.8255 11.1052 +5199 6 11.2229 22.8376 36.7897 -1.27591 2.9175 -5.69903 +5200 4 10.6623 23.4314 36.25 10.4728 -5.78036 -0.0474996 +5201 4 12.0147 22.5841 36.2713 -9.37786 4.28983 5.66853 +5202 6 18.9444 40.1485 39.92 -15.471 -8.01044 2.33142 +5203 4 19.1439 39.1941 39.9507 -1.34087 5.25319 4.4419 +5204 4 18.8847 40.4877 40.8271 3.43659 -8.21326 1.76593 +5205 6 23.5503 26.0803 21.2869 1.98517 -8.46863 16.2364 +5206 4 22.847 26.649 20.9475 -0.393515 -5.32061 4.06564 +5207 4 23.2913 25.6403 22.1336 -2.29953 13.2014 -21.5927 +5208 6 16.8518 5.38834 15.8565 -25.8193 5.07215 -6.0744 +5209 4 16.3979 5.3834 15.0179 8.08064 -16.6857 -11.3384 +5210 4 16.3642 6.13153 16.2159 17.5374 8.90145 23.838 +5211 6 12.0293 26.6115 15.0052 48.8575 28.3431 -20.5386 +5212 4 11.753 25.9113 15.557 -22.1508 -25.2102 16.954 +5213 4 11.3677 26.9943 14.4309 -20.7091 -9.23994 -0.184726 +5214 6 14.3404 41.4231 2.37222 21.8802 31.2536 -15.2067 +5215 4 13.6639 41.0433 2.88545 -29.1815 -25.4177 23.2655 +5216 4 14.3137 0.446574 2.65591 6.04323 -12.5169 -2.89291 +5217 6 50.3994 35.8721 9.32148 7.74023 -5.00078 -0.0244409 +5218 4 50.7985 35.7097 8.44539 1.7624 12.9821 5.72804 +5219 4 50.9327 36.5364 9.8137 -9.76519 -8.88391 -14.7497 +5220 6 11.3732 22.6657 26.8674 13.5542 4.36995 9.37334 +5221 4 12.2226 22.4007 26.49 -3.86507 -2.48494 3.34128 +5222 4 10.7274 22.4174 26.2153 -14.8849 -5.84603 -9.40936 +5223 6 8.44501 34.5567 21.2657 -4.1178 -59.9386 7.63204 +5224 4 8.06567 35.1301 21.9247 -8.42944 2.78434 16.8569 +5225 4 8.10966 33.58 21.4462 13.1168 58.8803 -11.2866 +5226 6 9.4289 8.66253 24.4817 -31.3326 14.2813 -20.5935 +5227 4 8.45611 8.64572 24.2655 24.8039 10.7682 6.42659 +5228 4 9.52915 9.21836 25.2644 -0.461641 7.68001 5.20174 +5229 6 32.603 22.3274 34.5057 1.1064 -2.38466 -37.2003 +5230 4 32.4525 23.1707 34.0368 4.85154 -2.46017 7.68642 +5231 4 32.8396 22.5701 35.3818 7.58742 14.9461 32.9529 +5232 6 26.736 26.1837 7.12165 10.4716 16.8024 -17.1295 +5233 4 25.9537 25.8031 7.51207 -7.84415 -15.2109 12.7352 +5234 4 26.4604 27.1054 6.93432 8.77765 -19.2484 4.4957 +5235 6 34.0014 11.9295 3.96807 -3.56186 4.82634 5.33773 +5236 4 33.6494 11.5631 4.78494 7.3544 2.33703 4.85457 +5237 4 33.8594 12.8842 4.06904 0.478869 -2.08104 -5.13073 +5238 6 21.473 20.924 37.1992 5.8677 19.4674 12.3893 +5239 4 22.3242 21.3752 37.157 2.6693 1.87465 3.04951 +5240 4 21.708 20.0203 37.0255 -6.20277 -25.1527 -1.47337 +5241 6 18.4792 41.0219 0.672743 -35.2491 -25.3697 -26.4792 +5242 4 17.5363 41.1592 0.451811 6.2729 -6.09178 6.10687 +5243 4 18.7532 41.8934 0.847545 18.5165 37.9853 8.81983 +5244 6 41.3458 41.7141 25.1818 17.8335 14.8146 -1.57438 +5245 4 40.8444 40.9381 25.3951 -6.7286 -20.9895 5.67055 +5246 4 41.5773 41.6158 24.2546 -2.61686 2.51709 -2.2804 +5247 6 27.6337 28.128 3.93443 68.2433 49.922 -72.4808 +5248 4 27.747 28.0641 2.90056 -5.60951 6.59214 55.905 +5249 4 26.974 27.5707 4.19301 -60.7891 -51.6503 16.466 +5250 6 18.2766 10.5218 31.4985 31.6557 -13.945 -4.11948 +5251 4 17.4661 10.038 31.5755 -21.8827 2.32902 1.26527 +5252 4 18.1351 11.463 31.4681 -8.30794 8.79106 3.21692 +5253 6 11.3047 37.9513 14.7719 14.2766 22.5792 8.51892 +5254 4 10.8196 37.2524 14.3384 -3.55752 -10.2024 4.33151 +5255 4 11.8722 37.607 15.4977 -19.1201 -2.12261 -16.4117 +5256 6 0.810718 18.1323 27.5767 30.9572 19.3393 -0.702274 +5257 4 0.190255 17.4711 27.3024 -13.6082 -17.9307 4.12615 +5258 4 1.6652 17.6816 27.7433 -15.3641 2.36995 -0.952151 +5259 6 36.7957 10.7342 20.2882 16.9593 17.0847 7.18326 +5260 4 36.2525 10.0089 20.0111 -13.8544 -11.0907 -5.31633 +5261 4 36.5766 10.8708 21.2175 -0.466777 -2.92115 4.06643 +5262 6 47.4269 25.5204 8.035 -8.77625 7.04012 -26.0141 +5263 4 47.2351 25.672 7.07342 16.0738 -5.10236 26.6147 +5264 4 46.6031 25.1946 8.38488 -7.38433 -0.0309169 8.21918 +5265 6 13.9121 35.1279 15.9963 57.6206 21.904 15.8158 +5266 4 13.18 34.6338 16.2776 -41.6081 -30.4219 4.97616 +5267 4 13.8612 35.4714 15.1124 -11.7278 3.29634 -19.5683 +5268 6 29.56 35.3617 16.1847 -46.2751 8.28104 -14.7299 +5269 4 30.2098 34.9035 16.6971 16.3841 -9.08849 15.1595 +5270 4 28.6495 34.9755 16.3324 34.0842 8.73794 -6.93478 +5271 6 29.4892 25.8842 32.4194 -24.256 -10.4352 -29.1805 +5272 4 28.8256 25.7516 33.0892 -1.91161 2.59937 23.0953 +5273 4 29.0388 25.4531 31.6468 24.6149 5.96309 7.68736 +5274 6 24.1242 2.12171 25.4449 33.2745 25.8541 -21.7468 +5275 4 24.4973 2.84525 24.8288 -6.14236 -31.0627 26.9036 +5276 4 24.7925 1.39916 25.5361 -16.9688 12.032 -10.1501 +5277 6 4.54733 34.4389 19.1463 -35.302 -7.10976 -3.39284 +5278 4 4.35486 34.5879 18.2161 16.9971 0.874352 -7.12679 +5279 4 3.63202 34.4395 19.5005 25.743 -3.14875 11.9651 +5280 6 10.1206 17.2361 14.3164 8.36708 -29.6599 -28.3251 +5281 4 10.306 17.5039 15.1955 -0.106022 16.7729 24.4966 +5282 4 9.5035 17.8022 13.8616 -7.59249 10.3925 2.01091 +5283 6 21.4437 41.7724 34.6698 -12.6382 -8.67476 11.1219 +5284 4 21.3209 41.1297 35.367 19.1323 -10.7035 11.8578 +5285 4 20.52 0.052046 34.4982 -0.738196 4.11389 -17.598 +5286 6 36.1618 24.1149 12.6039 -38.5184 -29.276 -18.6614 +5287 4 35.5274 23.7914 13.2897 25.4622 4.78071 -2.2183 +5288 4 35.751 23.7447 11.7708 17.6549 15.9976 15.8112 +5289 6 49.5813 18.6026 19.9424 19.3655 4.31785 -3.79274 +5290 4 50.05 19.3681 19.5461 -11.4841 -9.87428 2.01803 +5291 4 50.2881 17.9408 20.0283 -8.44417 3.53865 1.64593 +5292 6 1.24663 7.05846 14.4912 39.2605 -25.8072 -27.0237 +5293 4 1.83321 6.85564 13.6734 -27.5618 7.792 37.3713 +5294 4 1.40902 6.33035 15.1313 0.69425 14.6008 -10.3474 +5295 6 12.7431 22.7725 31.2519 -28.0711 -22.2846 -24.537 +5296 4 12.731 22.0484 30.5842 -1.03989 14.4355 17.1556 +5297 4 13.6361 23.0601 31.2889 29.0982 7.61123 0.941905 +5298 6 8.17623 18.6217 27.8167 28.4831 -7.95646 -20.137 +5299 4 8.40342 17.6669 27.8028 -7.19499 14.8132 8.92302 +5300 4 8.90402 18.9943 27.2753 -13.5351 -1.9306 8.34595 +5301 6 52.1398 28.0368 15.3061 -5.99984 -2.63203 -6.56281 +5302 4 52.212 27.4921 14.5152 3.50742 -7.1981 5.43712 +5303 4 52.1344 28.9249 14.9274 -1.52971 -5.17654 6.68842 +5304 6 52.6974 21.8977 10.081 -19.9085 6.90605 5.3514 +5305 4 53.3388 22.3376 10.626 19.2735 6.64212 5.60719 +5306 4 52.8023 22.3165 9.21858 0.448532 -1.39229 -3.54893 +5307 6 22.3312 5.79987 2.67028 14.2956 -6.96789 22.7666 +5308 4 22.4342 5.66665 3.62826 -7.95027 2.50856 -4.24886 +5309 4 22.7763 5.02131 2.34757 -2.68692 -18.1597 -17.0707 +5310 6 15.4178 16.2178 21.8878 29.1139 16.3559 -34.9346 +5311 4 14.4763 16.1482 22.0206 -17.0561 3.51129 1.66656 +5312 4 15.5967 16.6295 20.979 -16.1676 -12.6325 35.129 +5313 6 28.6996 41.2944 33.8986 -0.299799 0.972013 4.01662 +5314 4 28.6528 40.5712 34.5346 5.69191 -6.81028 -1.89437 +5315 4 27.7925 41.4039 33.5788 7.00998 2.71453 4.16387 +5316 6 9.0271 31.2603 18.2166 -24.0632 3.5617 9.69965 +5317 4 9.00312 32.2249 18.3215 -0.833429 -0.795431 1.49639 +5318 4 8.39564 30.8695 18.8792 23.5138 4.17381 -14.686 +5319 6 20.5401 20.4009 18.1765 -9.82111 13.5354 -7.0052 +5320 4 21.0961 20.6619 18.9088 6.00228 -1.57494 14.3732 +5321 4 19.8969 21.1451 18.1138 9.42471 -20.4088 -2.28899 +5322 6 53.9632 14.7108 37.8185 38.9936 -13.777 37.4998 +5323 4 53.5065 15.4999 38.0588 -19.2143 21.2037 -5.62994 +5324 4 53.6553 14.2856 37.0504 -18.643 -5.89619 -29.3657 +5325 6 28.9005 15.3805 18.8553 43.4355 2.75939 -10.7082 +5326 4 29.8744 15.2601 18.5577 -43.1698 -4.30042 15.6378 +5327 4 28.8821 15.3937 19.8257 1.95554 -2.72042 -0.550014 +5328 6 2.00757 25.8231 18.9102 1.56834 13.1457 16.4238 +5329 4 2.16994 26.6099 18.3718 5.10623 3.14141 1.15535 +5330 4 1.76535 25.1325 18.3092 -5.75322 -15.1157 -18.9078 +5331 6 53.2586 40.7003 24.294 -3.95682 23.2035 5.10337 +5332 4 53.3627 39.7881 24.0333 10.577 -13.1769 -1.30533 +5333 4 54.0929 41.151 24.0537 -8.8009 -7.19084 1.91562 +5334 6 47.531 32.0044 22.8424 -9.22212 4.73076 14.8806 +5335 4 47.3777 32.6735 23.5302 -5.63931 6.65432 -9.88941 +5336 4 48.2144 31.4763 23.2497 9.41484 -5.26157 -3.09765 +5337 6 24.6289 26.1478 33.0175 -22.0968 -9.02062 -12.6011 +5338 4 24.4656 25.5474 33.7557 -1.10221 8.12594 5.97613 +5339 4 25.4283 26.6445 33.1202 14.9272 4.196 4.65224 +5340 6 21.3417 17.0876 39.4763 -6.70912 6.89414 0.748051 +5341 4 22.0272 16.5901 39.8927 14.9242 -9.38388 2.18929 +5342 4 20.9728 17.5957 40.2063 -4.43123 6.71259 -1.60026 +5343 6 11.0417 40.4515 17.0271 -4.84825 -47.9733 -31.3307 +5344 4 11.617 41.1325 17.3235 21.4854 16.9952 0.793724 +5345 4 11.529 39.8797 16.3454 -22.439 27.66 32.3414 +5346 6 20.3522 21.2696 39.8718 -25.2322 13.8952 23.2629 +5347 4 20.7065 20.9823 39.0558 13.3567 -12.8249 -34.1322 +5348 4 21.0787 21.2544 40.4999 1.2931 1.07094 1.93889 +5349 6 2.11891 29.6947 22.5962 -10.9271 -4.15175 -1.48688 +5350 4 1.41229 29.0196 22.6861 11.0269 1.69063 -12.8134 +5351 4 2.97173 29.2673 22.4434 -6.16143 -1.40449 -3.11444 +5352 6 36.756 30.301 35.4561 22.3149 -30.6991 6.56967 +5353 4 36.1659 29.9908 36.1617 3.98829 10.9575 -2.82389 +5354 4 37.5905 29.761 35.5884 -25.1141 24.4323 0.251817 +5355 6 12.9563 4.31922 37.9158 -41.9162 -7.49401 17.923 +5356 4 12.213 3.67486 38.0016 27.2031 5.98064 4.05536 +5357 4 12.5797 5.11915 38.3509 20.8388 -3.72048 -10.4757 +5358 6 38.3368 5.25882 18.4553 -27.9454 13.7946 -11.1943 +5359 4 37.494 5.12162 18.8921 -4.17763 4.09508 -3.9191 +5360 4 38.9486 5.03087 19.1262 32.9808 -9.34357 19.7422 +5361 6 10.4991 9.23341 21.7308 -20.3579 1.12747 21.1104 +5362 4 10.1476 9.35811 22.629 -2.53412 -6.58654 -7.03761 +5363 4 11.4429 9.27697 21.8681 13.0367 -0.194449 -11.5952 +5364 6 0.510441 41.039 17.3204 -22.411 45.8537 -1.19125 +5365 4 1.10275 40.3438 17.515 21.9532 -27.5034 12.6219 +5366 4 0.955429 41.8901 17.5577 -0.403404 -22.4144 -8.21181 +5367 6 4.11028 5.06714 6.43108 -32.0559 -10.673 -25.0156 +5368 4 4.76196 4.43778 6.68194 21.2279 -22.0503 -6.17775 +5369 4 4.3376 5.79555 6.94869 8.69612 42.0455 26.6358 +5370 6 11.4527 25.4042 0.173069 -8.87291 20.1751 -4.43043 +5371 4 11.3037 26.302 0.51034 -2.48968 -2.12098 1.34892 +5372 4 12.3912 25.256 0.330533 -7.09022 -12.0676 2.67745 +5373 6 7.43008 21.5598 8.10589 6.84767 -16.7382 -30.018 +5374 4 7.67559 21.2373 7.18738 -12.1375 12.6211 33.8068 +5375 4 8.24892 21.8626 8.52003 -6.07298 -1.72571 -6.46698 +5376 6 47.5896 16.3642 25.2431 -28.5582 13.6976 -25.6498 +5377 4 46.6075 16.1608 25.1822 37.2389 5.55574 -4.66364 +5378 4 47.8562 16.8152 24.3682 -3.16196 -14.4146 40.515 +5379 6 30.9292 19.5125 39.8483 -41.4217 8.94898 -20.4144 +5380 4 31.859 19.4188 40.0164 22.9308 8.40553 1.58818 +5381 4 30.7224 20.3633 39.3589 16.5857 -27.3682 15.8932 +5382 6 20.3871 24.0387 39.4036 8.00795 23.2793 -8.75093 +5383 4 19.459 24.1701 39.2693 -20.2994 13.2523 2.58474 +5384 4 20.4244 23.1071 39.4874 5.50164 -36.2952 5.14995 +5385 6 45.8871 21.2471 41.1655 20.5283 25.7578 0.477301 +5386 4 46.6385 21.2626 41.7552 1.12624 -15.6366 20.1575 +5387 4 46.1812 21.9667 40.5962 -14.858 0.0662744 -14.6758 +5388 6 32.5732 28.1983 30.4559 17.8923 -19.7368 14.2663 +5389 4 32.9661 27.3096 30.6426 -14.7491 22.8943 -8.37245 +5390 4 33.2232 28.8091 30.8453 -8.57676 -1.81844 -4.53088 +5391 6 18.0207 1.32021 27.0363 -34.7874 1.53884 20.0911 +5392 4 17.0721 1.60205 27.1202 27.3864 -5.2263 -11.315 +5393 4 18.3294 1.50373 27.9381 11.4124 1.84961 -11.8648 +5394 6 39.378 24.9761 21.8758 -21.83 -3.15726 3.51608 +5395 4 39.2925 25.9351 21.9975 13.0773 -1.30024 -1.60914 +5396 4 38.5262 24.6687 22.2439 10.6836 3.42961 -4.87158 +5397 6 33.5904 21.3057 22.0908 0.876878 23.3779 1.34154 +5398 4 32.7037 21.4589 21.7601 -6.64994 -10.6299 -4.35651 +5399 4 34.0298 22.1428 21.8479 4.87062 -13.8873 3.79153 +5400 6 40.1162 15.0006 15.7553 -16.7667 -72.1851 -56.1125 +5401 4 39.3246 14.5665 15.2764 38.6699 22.9899 20.5541 +5402 4 39.7685 15.7046 16.224 -23.0828 51.553 35.6364 +5403 6 32.7063 17.9241 6.36312 -6.65812 28.0098 -27.693 +5404 4 32.6631 17.3286 7.08836 -4.96405 -26.2659 23.6138 +5405 4 32.2202 17.5402 5.61621 0.349997 -9.22032 2.43078 +5406 6 50.4717 15.9308 31.1336 -57.0185 -34.1342 43.3708 +5407 4 51.2677 16.1483 30.7347 55.5832 16.4654 -29.6643 +5408 4 50.5499 15.0059 31.4683 -2.42192 20.1529 -11.8828 +5409 6 23.8292 29.3322 31.6407 10.3974 -8.56959 5.42825 +5410 4 23.7096 29.6981 30.7618 4.3803 -0.813234 -2.10966 +5411 4 24.6813 28.8378 31.6594 -15.3785 13.3689 -4.34977 +5412 6 25.0524 41.6477 38.2806 4.00174 7.46449 -31.3583 +5413 4 25.6511 41.367 37.5454 -10.3054 -0.491554 23.0497 +5414 4 24.5276 0.474703 37.8884 8.98972 -6.87862 14.9811 +5415 6 14.3299 25.4693 7.99598 -51.8246 -23.5651 26.6357 +5416 4 15.0301 25.7523 7.4663 39.147 18.3395 -31.3738 +5417 4 13.6749 25.0466 7.38907 19.2382 9.49844 7.52052 +5418 6 17.2117 20.7467 5.34291 -12.6959 30.9635 29.5807 +5419 4 17.5658 20.2645 4.6512 13.3362 -42.6322 -45.6451 +5420 4 17.6752 21.5763 5.21476 -4.76461 12.1014 12.8322 +5421 6 18.8578 10.961 23.7113 11.9098 -52.6755 14.4862 +5422 4 18.5821 10.3312 23.0139 -2.7304 18.9854 0.947207 +5423 4 18.7069 11.8432 23.4586 -8.32501 34.3086 -18.4054 +5424 6 7.80658 41.3805 11.0401 -9.04392 11.0606 6.15122 +5425 4 8.00429 40.5098 11.4059 2.67644 4.01258 -4.23655 +5426 4 8.51691 0.066 11.3394 -1.81513 -7.16892 -1.05394 +5427 6 48.6966 23.1832 34.0648 -27.3561 -6.76338 -18.0805 +5428 4 48.0792 22.9132 33.32 19.6766 11.2437 24.8207 +5429 4 49.5669 23.23 33.6693 11.2336 0.854645 -6.12438 +5430 6 53.7246 23.5588 15.3422 -2.2993 4.88061 -38.5045 +5431 4 54.0115 23.9686 14.4981 1.04624 9.96871 20.6807 +5432 4 53.2132 22.8493 14.9574 -7.54922 -9.79714 16.7607 +5433 6 22.2409 5.63035 9.83732 -4.74687 0.990813 -28.4051 +5434 4 21.8007 4.9012 9.36518 5.41421 2.33681 17.3637 +5435 4 22.5704 6.16354 9.07597 -3.08255 -9.23766 25.1176 +5436 6 33.6677 8.38805 9.07277 4.65141 2.45263 2.68713 +5437 4 32.9476 8.96499 9.32099 -11.143 10.7473 10.4723 +5438 4 33.4213 8.08448 8.2012 2.38155 -0.0587928 -10.5973 +5439 6 47.3188 37.7205 20.3441 15.215 11.7573 -25.0114 +5440 4 47.5704 37.5879 19.4187 8.2864 3.06637 8.88956 +5441 4 46.6261 37.0853 20.3703 -21.7602 -22.9037 19.9419 +5442 6 30.8605 16.7391 10.6102 -28.0995 -48.2853 23.2284 +5443 4 30.4428 17.1675 11.4048 8.00556 -5.70758 -17.8294 +5444 4 30.5213 15.7576 10.5828 6.17084 54.1408 -3.58748 +5445 6 48.1227 27.723 10.1192 -17.271 38.6552 19.8549 +5446 4 48.941 27.5885 10.6019 15.4404 -6.10886 -7.64033 +5447 4 47.9667 27.1056 9.42146 1.69339 -23.2576 -13.9441 +5448 6 27.3465 38.6397 25.5972 -19.3603 -43.7567 25.3821 +5449 4 28.2552 38.3171 25.6348 3.73027 6.4174 -6.06634 +5450 4 27.3175 39.4354 25.1025 9.7616 28.5552 -11.1584 +5451 6 33.3485 5.72785 21.4502 -30.5322 15.1217 -10.2054 +5452 4 32.7106 6.21453 20.8566 24.3968 -18.0484 15.2917 +5453 4 34.2142 6.02589 21.2258 21.3261 10.3595 -12.9949 +5454 6 25.3097 5.14436 4.52462 -12.6707 -6.42781 10.7366 +5455 4 25.8166 5.03621 5.34324 9.24373 -0.000563512 -7.52253 +5456 4 24.4109 4.89546 4.80865 9.45245 1.955 -8.20101 +5457 6 40.4804 35.6472 19.1595 -4.18239 -17.2552 -25.1441 +5458 4 40.6473 35.1871 19.989 -0.677015 6.66802 10.9293 +5459 4 40.3876 36.5867 19.2889 2.08163 9.85771 9.62751 +5460 6 49.6466 30.6357 19.0258 14.8172 21.4531 -43.5404 +5461 4 50.0494 29.991 18.4245 -6.82309 -11.6442 2.45506 +5462 4 49.4912 30.1943 19.8303 -8.11919 -24.8089 39.0949 +5463 6 42.1414 28.3198 17.0336 30.9261 -8.96587 16.5499 +5464 4 41.9014 28.1134 16.1233 0.612516 -1.09878 -6.61247 +5465 4 42.9986 27.8356 17.2327 -32.0588 11.6021 -17.9905 +5466 6 47.7009 24.529 36.3602 12.6164 -10.6945 -29.4467 +5467 4 46.9511 23.9476 36.4057 -12.614 -6.01445 14.1932 +5468 4 48.02 24.3175 35.4647 6.89481 1.31964 6.68358 +5469 6 19.3487 26.9773 19.8132 -7.91098 29.1703 -3.69101 +5470 4 19.5772 26.0513 19.7652 -2.42994 -17.6971 2.90599 +5471 4 18.7132 27.1892 20.5145 5.94626 -13.5516 -3.80193 +5472 6 47.0594 26.8038 37.5124 29.171 -27.35 55.5912 +5473 4 46.5442 27.3901 37.0243 -28.7601 35.2651 -40.4696 +5474 4 47.4575 26.1126 36.9775 -8.83233 1.8809 -11.4479 +5475 6 9.306 24.6801 40.2841 31.4937 0.109789 0.329283 +5476 4 9.78189 23.9102 39.8717 -14.0424 16.7407 17.3327 +5477 4 10.0272 25.2082 40.7306 -19.6308 -16.1327 -14.1874 +5478 6 14.4855 17.9139 14.2735 23.8217 -2.3356 -5.96097 +5479 4 13.7756 18.1909 13.6871 -0.445295 3.10639 3.20472 +5480 4 15.2926 17.8532 13.6969 -24.9099 1.36359 15.4275 +5481 6 37.1333 38.6708 18.7289 9.24178 15.507 -32.6939 +5482 4 36.7257 39.5382 18.5851 -4.02817 -0.227247 6.07181 +5483 4 37.6697 38.5833 17.9067 -2.91955 -11.3843 16.172 +5484 6 11.4153 5.92336 21.4477 15.4675 -15.5323 24.3843 +5485 4 12.0347 5.46444 22.0611 -14.8481 11.1792 -11.8992 +5486 4 10.9828 5.22117 20.955 -5.02219 -4.37746 -7.57367 +5487 6 4.24672 30.7112 16.2271 25.0754 -37.7862 10.5022 +5488 4 4.05441 31.4608 15.7204 -4.71706 34.9582 -31.1175 +5489 4 3.72964 30.8334 16.9988 -11.892 -2.06994 24.4228 +5490 6 17.6689 16.0105 27.0706 -11.532 -19.4613 -16.5334 +5491 4 17.475 15.0322 27.0999 0.550485 29.0366 -12.0979 +5492 4 17.2014 16.3875 26.2691 10.8221 -16.0252 20.0561 +5493 6 36.4979 8.6445 40.4253 22.1182 5.90925 -1.87084 +5494 4 36.6649 9.56092 40.6574 -3.64727 2.10984 0.486612 +5495 4 35.6642 8.36755 40.7885 -12.5441 -1.64485 2.44437 +5496 6 13.6104 12.9476 3.01337 -0.796658 -1.76047 52.4558 +5497 4 13.281 12.534 3.85665 2.0295 3.09436 -35.1239 +5498 4 14.3672 13.4568 3.35498 1.79634 -1.71495 -16.7359 +5499 6 38.5663 20.1511 21.6276 16.2684 -2.59448 10.3838 +5500 4 39.225 20.3435 20.957 3.66548 0.723189 -1.42015 +5501 4 37.7399 20.1987 21.178 -26.4348 -4.9091 -11.1397 +5502 6 51.0002 10.2707 30.836 -20.0759 -41.5967 21.7358 +5503 4 51.4945 11.0341 30.626 15.2265 30.1997 -10.6067 +5504 4 50.365 10.1656 30.1217 2.42758 1.75416 -9.76943 +5505 6 16.2768 2.44039 41.3342 24.5898 23.894 -47.9169 +5506 4 15.7659 1.68969 41.4668 -26.4768 -52.1654 31.458 +5507 4 16.2309 2.46185 40.3616 9.12406 8.41144 7.6857 +5508 6 16.5823 4.96192 41.8916 -4.82165 52.2801 -70.6027 +5509 4 16.7504 4.9538 0.881833 10.2709 -3.72182 62.3109 +5510 4 16.3825 4.09214 41.6138 -6.48385 -26.7637 5.90228 +5511 6 38.2132 37.6512 20.9834 35.6931 -0.0015793 9.16781 +5512 4 38.1132 38.2158 20.1985 1.71026 -5.63736 5.42755 +5513 4 39.175 37.679 21.2752 -35.8773 5.52261 -11.9395 +5514 6 27.3063 1.90932 15.7743 -36.1781 7.04456 22.02 +5515 4 27.5288 1.21363 15.1745 3.62804 -9.29946 -19.0329 +5516 4 26.3092 1.89423 15.8276 27.8398 0.929522 -3.41863 +5517 6 29.0129 12.4346 37.8081 29.6396 -2.3639 23.3235 +5518 4 29.5703 13.228 37.8521 -9.25731 3.38449 -11.2245 +5519 4 29.432 11.8866 38.5178 -20.735 6.92768 -10.3763 +5520 6 46.0725 20.1624 18.9069 6.39102 14.9163 -14.6323 +5521 4 45.1723 20.516 18.8892 1.91785 -0.379773 0.405435 +5522 4 46.587 20.7656 18.3221 -3.54001 -13.7442 9.74416 +5523 6 2.03634 38.6845 18.4933 3.82981 -3.85695 21.6638 +5524 4 2.81563 38.6864 19.0472 23.4807 10.2435 -12.678 +5525 4 1.45125 38.3557 19.1766 -27.1945 -1.99387 -8.3623 +5526 6 44.0469 24.9707 25.966 7.80173 10.6441 20.9452 +5527 4 44.2747 24.0363 26.0952 1.37736 2.33249 -4.33209 +5528 4 43.5784 25.0701 25.1359 -3.49858 -7.6437 -6.59112 +5529 6 5.98346 26.6137 4.53144 23.0758 4.04073 24.4329 +5530 4 6.55391 27.1627 5.13089 -15.1794 -12.3526 -15.6845 +5531 4 6.29729 25.6938 4.67268 -13.7287 18.2257 -9.78447 +5532 6 0.087877 23.2081 10.934 24.9145 3.46447 1.10559 +5533 4 0.685292 23.7315 10.3726 -8.08066 -2.01306 3.92681 +5534 4 0.721975 22.7627 11.5282 -19.4067 -0.934622 -1.78644 +5535 6 39.1228 20.6282 12.8796 23.5823 -4.01912 3.74068 +5536 4 40.0483 20.9095 13.1274 -25.2182 -11.8294 -4.75086 +5537 4 38.9288 21.0058 12.0111 3.51405 8.21934 1.48951 +5538 6 39.9585 39.9542 18.8548 8.25477 7.63818 -34.14 +5539 4 39.6086 40.5348 18.1328 12.8912 -23.3113 16.3656 +5540 4 39.4227 40.1355 19.596 -22.4924 5.25798 25.9214 +5541 6 49.2764 23.011 30.5163 -3.77364 -44.6036 15.8547 +5542 4 49.4289 23.7872 30.0082 18.6126 30.182 -14.9565 +5543 4 49.9621 22.8706 31.1946 3.66181 18.5012 -4.70792 +5544 6 10.3518 2.34263 9.13761 -0.60969 70.0656 33.4022 +5545 4 10.2194 1.51752 8.76453 -19.3013 -48.5596 -30.1763 +5546 4 9.57958 2.95755 9.02478 16.8019 -18.7251 -1.57756 +5547 6 9.61453 40.9339 19.7468 19.8516 -54.9951 -16.0575 +5548 4 9.63195 40.6865 18.7859 0.317082 16.3896 20.6195 +5549 4 10.0376 40.0904 20.1458 -24.9194 43.0231 -10.2629 +5550 6 29.2525 5.10109 17.4961 7.67774 22.6856 2.90325 +5551 4 29.0408 4.77134 16.6193 -6.82779 -3.03985 -6.7526 +5552 4 29.5295 6.02934 17.3335 -2.58265 -16.5067 4.76001 +5553 6 27.0985 15.4102 3.23556 -13.4453 -81.1273 -7.3603 +5554 4 27.3652 16.2806 3.27349 18.8182 67.1491 11.283 +5555 4 27.7776 14.8512 3.68225 -14.3437 21.6428 -0.863725 +5556 6 32.8444 39.3852 25.121 -7.01244 -52.8845 44.4676 +5557 4 32.5131 40.2222 24.9368 -10.8075 51.8916 -16.2411 +5558 4 32.4445 39.2315 26.0289 16.1191 -0.874654 -30.671 +5559 6 34.9513 7.88207 31.2328 20.4504 58.5219 2.42802 +5560 4 34.2036 8.45679 31.498 3.65199 -12.2289 -1.35309 +5561 4 34.6861 6.99719 31.2488 -20.0023 -44.0519 1.25651 +5562 6 6.12467 36.7605 26.1486 23.5936 30.152 20.8626 +5563 4 6.61267 37.4751 26.6609 -18.7565 -29.2185 -15.3031 +5564 4 6.64666 36.6639 25.3566 0.873799 -8.15108 -9.63468 +5565 6 6.01736 25.8242 24.1032 -23.71 11.4997 43.6127 +5566 4 6.27054 25.4519 24.9889 5.69321 0.899098 -34.3464 +5567 4 5.25039 26.3671 24.4036 11.002 -12.3451 -22.9516 +5568 6 45.616 24.3868 2.54557 6.93899 11.9467 -1.18645 +5569 4 46.5025 24.2318 2.18535 0.269069 -11.0786 2.08994 +5570 4 45.6283 24.2142 3.48441 5.93067 -6.10702 12.3332 +5571 6 15.5106 11.7053 32.6869 22.7313 15.5035 25.4621 +5572 4 15.7644 12.551 33.1413 -9.31293 -24.2108 -12.4541 +5573 4 14.956 11.9719 31.9681 -12.2379 8.7831 -14.7046 +5574 6 46.4141 17.7037 37.4783 -24.8433 -42.9552 -46.1347 +5575 4 46.5841 17.8832 38.3706 6.4658 9.03355 44.3658 +5576 4 46.0203 16.778 37.4148 6.08678 36.5836 2.96135 +5577 6 39.713 20.917 18.528 13.2313 30.5311 40.8197 +5578 4 40.433 20.5782 18.0298 13.2747 -18.0123 -24.5712 +5579 4 40.2054 21.5165 19.1543 -30.2447 -12.7963 -15.6911 +5580 6 23.8051 28.0334 36.6648 -18.7533 17.1228 48.8478 +5581 4 23.301 27.37 37.1661 8.15196 -5.41595 -20.5023 +5582 4 23.699 28.7533 37.3439 14.557 -4.10395 -29.4534 +5583 6 23.235 0.659798 30.8906 16.7198 -34.3804 0.301059 +5584 4 23.3562 41.8891 31.5781 -2.93034 5.1259 -1.85649 +5585 4 23.9222 0.433479 30.2226 -16.4688 10.6885 3.12481 +5586 6 37.1438 6.89027 28.2945 -2.75708 2.50278 32.0481 +5587 4 36.7625 6.23385 28.9496 14.7229 22.3106 -21.8828 +5588 4 37.4874 7.65333 28.8474 -13.0775 -21.14 -18.6628 +5589 6 3.23769 6.61111 12.3846 0.723209 -17.9385 -9.61551 +5590 4 2.93962 6.7917 11.4726 6.04883 11.0603 10.3219 +5591 4 3.59705 5.70622 12.3141 -7.8292 10.6871 9.81534 +5592 6 12.6213 19.1513 31.1215 -11.7593 -39.2703 -9.13055 +5593 4 12.5689 18.1911 31.4279 4.41954 36.1073 -0.401864 +5594 4 12.3049 19.0952 30.1995 4.23471 8.33584 13.9505 +5595 6 15.1895 38.3194 41.5508 -8.26313 0.106571 5.96729 +5596 4 15.4027 38.685 40.6867 1.58925 3.7734 1.08261 +5597 4 15.977 37.8419 41.8199 8.82113 -1.67422 -0.112624 +5598 6 49.6344 33.3417 19.6414 -43.1776 -42.2962 -0.847743 +5599 4 48.6794 33.3996 19.9697 35.2792 3.84356 -17.7841 +5600 4 49.66 32.3974 19.2778 11.8172 40.1309 17.1575 +5601 6 6.36572 2.78375 29.9004 1.05055 15.8156 -22.8281 +5602 4 6.36575 3.75042 29.7262 1.90425 -15.9719 7.25575 +5603 4 5.96593 2.68858 30.7619 0.24665 -4.47807 16.8647 +5604 6 13.1696 31.768 30.2754 -6.44409 10.1839 -14.6274 +5605 4 12.7931 32.0108 29.386 8.00869 -8.49993 19.6421 +5606 4 12.9985 30.8211 30.4317 -1.17466 7.15103 -3.10169 +5607 6 32.315 32.2433 24.9103 28.3535 -13.0924 -48.465 +5608 4 32.6582 31.5201 24.3183 -18.8106 4.4732 28.5514 +5609 4 32.6906 33.004 24.4312 -3.21058 9.63112 20.1287 +5610 6 42.0003 14.5628 37.421 -39.889 12.6212 -8.37855 +5611 4 41.095 14.1415 37.3281 37.9102 -1.96214 -0.320241 +5612 4 42.7025 13.9066 37.3517 -4.02931 -15.6388 2.60245 +5613 6 11.8892 7.23447 27.6701 3.45884 -4.12236 4.5236 +5614 4 11.8415 6.40302 28.2109 -4.80024 17.2153 -14.4092 +5615 4 11.297 7.16355 26.8983 -0.411327 -9.99206 8.34553 +5616 6 14.2054 37.5349 6.88535 -5.50304 -50.1586 -23.8091 +5617 4 14.4448 38.4425 6.82842 11.1201 34.2121 -5.16838 +5618 4 14.5404 37.0855 6.04727 -8.45912 19.5264 31.302 +5619 6 14.2389 30.7101 36.0658 7.9951 22.3707 -6.00421 +5620 4 14.3369 30.7582 35.119 5.20948 5.89711 -15.5268 +5621 4 14.162 29.7856 36.1796 -2.50712 -40.828 17.27 +5622 6 16.4199 33.6465 5.49971 39.8982 -12.4718 -37.0106 +5623 4 16.8881 34.472 5.38053 -10.1033 13.7438 12.8324 +5624 4 16.9383 33.116 4.82328 -31.4907 -2.1142 22.2677 +5625 6 23.0347 17.1509 7.84843 -2.98061 53.305 10.417 +5626 4 22.2528 17.4913 7.37616 0.35347 -20.1342 1.7373 +5627 4 23.3535 18.0122 8.2624 2.91922 -40.8936 -9.01863 +5628 6 51.739 20.8998 27.7117 45.1346 -9.91933 19.8422 +5629 4 51.4539 20.5938 28.5983 0.576611 5.87017 -14.8878 +5630 4 52.7517 20.9693 27.7878 -43.3794 -0.870523 -11.1135 +5631 6 2.19386 27.6013 28.8077 21.9852 1.77593 -20.6905 +5632 4 2.90112 28.2633 28.7865 -8.94698 7.25322 21.5481 +5633 4 2.57794 26.9939 28.1568 -21.2327 -10.3447 8.82052 +5634 6 17.2209 14.3445 7.70498 -9.6153 -40.0176 25.3709 +5635 4 16.7414 14.2178 8.5755 19.2823 5.01031 -25.0594 +5636 4 17.7242 13.4894 7.54274 -12.7499 32.9606 1.11211 +5637 6 12.4553 8.94194 14.7093 23.4905 -30.5738 22.1451 +5638 4 12.3295 7.96561 14.6517 -10.6336 18.1935 -14.5798 +5639 4 13.0902 8.95069 15.466 -13.8235 22.031 -14.7981 +5640 6 42.4163 38.0607 9.75492 -41.3892 12.3524 0.930734 +5641 4 43.2155 37.8504 10.1985 23.5031 -2.65638 19.8551 +5642 4 41.8128 38.5249 10.3845 19.1619 -5.0707 -9.72644 +5643 6 51.8291 30.3524 28.2725 -23.4976 -15.3182 24.0858 +5644 4 51.4769 31.1806 28.0071 -16.9091 20.9854 -6.54852 +5645 4 52.5669 30.2698 27.7075 37.0459 -10.0857 -13.876 +5646 6 0.173291 18.5306 4.58887 -6.78508 26.3933 6.63194 +5647 4 0.366643 18.0957 3.77581 2.61413 -8.62723 -27.1515 +5648 4 0.528197 17.9664 5.25604 0.668563 -20.2899 17.5992 +5649 6 34.1542 0.618182 3.01035 -64.6642 7.59467 -29.5426 +5650 4 33.2756 0.91071 2.55681 38.9521 -14.8268 28.0312 +5651 4 34.8139 1.0189 2.46529 20.392 14.9436 -5.19898 +5652 6 49.1703 17.2445 23.163 11.3421 -28.7232 -23.3687 +5653 4 50.0948 17.5226 22.997 -11.4987 -1.8789 7.34388 +5654 4 49.1149 16.3391 22.7575 3.35316 27.0342 8.27414 +5655 6 23.1508 6.50484 23.6205 15.3745 23.1125 -33.0506 +5656 4 23.1854 7.14565 22.8174 -14.1016 -25.0292 28.8988 +5657 4 22.2566 6.27815 23.8868 -11.3625 11.3028 -1.57795 +5658 6 11.0777 24.0866 29.2726 3.42799 -14.5151 -26.2344 +5659 4 11.3051 23.4915 28.5104 -10.7193 12.1306 15.2701 +5660 4 11.7189 23.8646 29.9475 6.00027 1.59973 10.1126 +5661 6 36.5499 4.08922 21.6769 -9.80126 5.87302 -21.3361 +5662 4 36.3976 4.50823 22.521 3.21878 -0.144303 13.033 +5663 4 36.3054 4.80832 21.0596 6.63301 -13.9203 1.83546 +5664 6 31.3023 25.6432 24.5943 15.0376 6.85795 28.0728 +5665 4 31.291 26.2789 25.3519 -12.6017 -14.5788 -25.478 +5666 4 32.0941 25.1064 24.7955 -9.59576 -0.449362 -7.93794 +5667 6 42.6065 23.029 14.7662 -46.2562 -12.0705 -53.1337 +5668 4 42.8654 23.3474 13.8766 8.33796 6.77145 13.2285 +5669 4 43.1929 23.285 15.4255 44.8404 21.8098 38.991 +5670 6 14.3111 11.6689 8.88632 -19.0153 -23.9468 -21.906 +5671 4 13.3495 11.3817 8.87766 31.9146 14.5471 0.24728 +5672 4 14.742 11.0378 8.25313 -7.14597 12.5116 20.7778 +5673 6 21.4992 2.13393 3.40246 8.36864 -2.88126 -9.61958 +5674 4 22.4231 2.22963 3.69686 -12.58 -3.45743 -2.69439 +5675 4 21.4721 1.34946 2.81138 2.62282 6.56171 18.4043 +5676 6 22.4667 27.6841 39.0793 -16.1771 -11.2193 -33.3168 +5677 4 22.9487 28.2311 39.6723 13.8114 13.1168 21.0188 +5678 4 22.2331 26.8853 39.529 -0.753476 -8.75647 11.2468 +5679 6 37.2752 33.5075 30.0534 -5.09816 -29.8969 21.2662 +5680 4 36.5321 32.9121 30.2938 11.1992 13.6878 -5.37502 +5681 4 38.0391 33.1092 30.5204 -9.59535 7.6329 -11.7718 +5682 6 41.8356 20.8755 40.0084 -30.1785 -26.2846 -15.3963 +5683 4 40.891 20.6843 40.2338 21.7839 7.55089 -6.55796 +5684 4 42.213 21.2736 40.7728 12.4306 8.07023 23.0746 +5685 6 10.0585 31.1051 22.2503 24.8691 -18.1602 32.094 +5686 4 10.0242 30.9652 23.2199 -0.323131 -4.21186 -18.2592 +5687 4 9.26251 31.5457 22.0526 -32.5358 14.9165 -12.561 +5688 6 24.2061 35.3797 6.65176 29.8647 -7.74501 -52.0461 +5689 4 23.2981 35.13 6.46942 -12.5131 3.59528 11.7489 +5690 4 24.436 35.6291 7.5325 -13.5066 3.92126 26.0938 +5691 6 54.2205 13.3707 18.7548 -14.8606 0.23157 2.49876 +5692 4 53.5905 13.2954 18.0026 12.0308 5.79113 16.3195 +5693 4 53.7072 13.5032 19.578 4.97112 -2.65932 -16.1217 +5694 6 12.4895 25.0856 17.4479 -5.54126 21.12 19.6166 +5695 4 12.0527 25.8035 17.9613 1.96295 -15.4272 -10.9144 +5696 4 12.9797 24.5872 18.1192 -7.22993 -2.38631 -13.5888 +5697 6 22.3914 33.9622 18.8899 -17.7941 -3.8788 -25.186 +5698 4 22.7777 34.3519 18.0802 1.20341 3.55679 12.7761 +5699 4 21.5828 33.5138 18.532 26.0363 5.82114 13.25 +5700 6 24.4442 12.917 5.83205 -1.35281 -9.13891 6.68087 +5701 4 24.5112 13.8355 6.04562 11.139 23.8521 5.95609 +5702 4 23.7978 12.9208 5.12829 -4.38592 -8.75699 -5.70796 +5703 6 13.4045 11.2384 28.602 -9.94106 -32.5269 -0.345522 +5704 4 13.7125 10.4202 28.1467 1.06973 22.7078 1.68844 +5705 4 12.6883 10.856 29.1417 2.50959 12.0169 -5.49025 +5706 6 20.9681 34.6931 21.1354 15.1203 14.42 -6.16036 +5707 4 21.5009 35.1121 21.8248 -8.94458 -7.77672 4.1779 +5708 4 21.5063 34.8208 20.3262 -11.2236 -10.4562 8.09593 +5709 6 37.1336 34.5207 26.1541 -9.5297 -36.7224 -3.07541 +5710 4 37.2109 34.2142 25.2288 3.21082 15.1766 11.7274 +5711 4 37.5352 35.3664 26.2639 8.9577 18.3348 -6.65469 +5712 6 49.3622 27.1182 23.4746 39.7066 -11.0301 13.9767 +5713 4 48.4746 27.3502 23.3119 -43.65 9.96054 -8.06751 +5714 4 49.6716 26.7458 22.6451 -3.30563 -9.15784 -7.68388 +5715 6 2.6564 41.733 27.6477 -1.65257 -10.3676 0.180548 +5716 4 2.5349 41.5868 26.6785 2.71482 14.5166 10.808 +5717 4 3.44733 0.360291 27.8573 -13.8821 -2.9337 -13.5775 +5718 6 28.2538 5.65865 0.855763 -50.2522 -11.1502 7.99105 +5719 4 29.1126 5.92525 0.635025 43.8938 8.11388 -11.2713 +5720 4 28.2366 4.68907 0.832778 5.05155 4.08711 2.73992 +5721 6 46.3376 19.9476 30.6448 -5.32264 7.02196 22.3264 +5722 4 46.9473 19.8004 29.9179 3.84913 9.17517 -5.42643 +5723 4 46.6125 20.7672 31.1318 -5.12963 -19.3092 -16.4827 +5724 6 3.64577 25.7701 21.5553 -12.766 27.4814 -12.397 +5725 4 3.72382 24.8593 21.8343 3.84868 -9.88757 -5.52558 +5726 4 3.13913 25.8588 20.7173 13.2009 -15.3518 9.10855 +5727 6 2.75122 19.0968 29.6319 -2.61118 -0.882922 8.96218 +5728 4 3.5891 18.6871 29.8565 3.14038 -9.81989 10.1431 +5729 4 2.90737 19.4327 28.7602 3.1882 14.1904 -12.7773 +5730 6 11.8953 35.7778 24.2646 -23.8517 23.4638 0.926703 +5731 4 12.2722 34.9198 24.2954 23.5909 -23.1933 0.784725 +5732 4 12.5229 36.3761 23.8548 12.2449 3.68762 -3.83655 +5733 6 52.3409 30.3775 14.3038 25.9342 24.3497 3.27132 +5734 4 52.8186 31.1218 14.7277 1.28259 -10.3571 -1.87569 +5735 4 51.5459 30.7912 14.0165 -25.7225 7.74731 -5.34623 +5736 6 0.083662 24.3704 32.1159 7.87696 -1.86575 0.949534 +5737 4 0.925887 24.7254 31.8116 -7.58302 1.2158 -10.0766 +5738 4 0.064605 24.6797 33.0182 -11.6947 5.89195 12.8097 +5739 6 31.4941 23.7355 38.8139 13.6067 4.55671 22.3988 +5740 4 31.5922 23.3599 39.6955 6.6148 17.5079 8.63317 +5741 4 30.9989 23.0266 38.4646 -21.4094 -18.5611 -29.2329 +5742 6 52.1193 21.6104 3.49599 14.6151 -31.0847 -13.388 +5743 4 52.9641 21.5934 2.99085 -20.8635 4.42776 5.19501 +5744 4 52.1025 22.4297 3.95509 1.85636 27.8943 8.87727 +5745 6 31.7523 33.9412 11.6017 9.59211 -24.6365 -8.99112 +5746 4 31.343 34.2459 12.4067 -7.95657 10.1636 10.9534 +5747 4 32.0734 33.0348 11.7994 -4.73133 20.193 -2.42319 +5748 6 7.03486 17.6719 16.6685 29.0057 -41.5114 -49.367 +5749 4 6.91092 17.0215 17.3537 -7.78637 4.64801 28.8113 +5750 4 7.29826 17.0034 15.9319 -18.9591 50.1453 28.7374 +5751 6 51.8542 41.8728 22.1898 10.246 17.2442 -13.5357 +5752 4 52.3028 41.4443 22.9054 19.3182 -6.61148 18.5368 +5753 4 51.1068 41.3135 22.0792 -27.0964 -11.4612 -2.03348 +5754 6 50.8737 9.93347 25.9376 -32.929 -21.31 0.307119 +5755 4 50.6075 10.0984 25.0351 -2.54905 2.45869 -5.94774 +5756 4 51.7134 10.3221 26.0527 29.2363 20.0336 5.9403 +5757 6 9.00178 39.8723 13.8451 -19.3622 -18.1235 -30.983 +5758 4 9.55792 39.3182 14.3856 9.60602 -5.37935 8.26515 +5759 4 8.70771 39.29 13.0873 14.4347 20.6992 23.854 +5760 6 40.6986 25.5526 0.136544 19.9096 -17.3535 33.0343 +5761 4 40.3666 25.3638 1.04053 0.834228 7.76146 -13.9079 +5762 4 41.6521 25.7245 0.296606 -16.7956 -8.725 -14.7957 +5763 6 46.6823 7.83196 22.8561 10.1499 25.8504 33.9562 +5764 4 46.2788 7.49308 23.6743 -2.78909 -8.0392 -13.1915 +5765 4 47.099 8.65892 23.1926 -4.50937 -8.82075 -14.1875 +5766 6 20.9875 12.9068 9.95805 -11.691 32.2034 24.7109 +5767 4 21.4351 12.3054 10.5167 21.854 -26.8991 22.1196 +5768 4 21.3309 12.7465 9.11062 12.4417 -9.66517 -44.3579 +5769 6 24.8453 0.514421 28.6038 13.082 22.7197 -2.81433 +5770 4 24.715 0.071792 27.7548 -6.16819 -1.63374 -2.91335 +5771 4 25.0442 1.45997 28.4028 -6.72102 -19.281 3.08734 +5772 6 9.94041 22.6855 8.28517 -18.2906 18.759 -35.6321 +5773 4 10.3442 21.9586 7.83344 17.071 -18.1108 1.7387 +5774 4 9.60436 23.1702 7.48056 7.13277 7.40532 33.7222 +5775 6 33.2759 9.25429 23.8257 8.37106 -55.2845 13.9355 +5776 4 33.3237 10.1123 23.4806 -1.26345 47.1757 -20.4798 +5777 4 34.1087 8.81977 23.5578 -8.47821 6.16632 5.2483 +5778 6 47.7984 20.3614 34.2959 -41.6158 20.0741 -32.6301 +5779 4 47.162 20.9095 33.7523 35.4977 -6.5354 18.8426 +5780 4 47.2264 19.5923 34.4121 13.8381 -6.37745 11.1074 +5781 6 7.49292 13.4971 41.09 9.79805 -11.8131 -23.6679 +5782 4 7.49901 13.1324 40.1715 -6.0705 12.8605 17.5951 +5783 4 8.32745 13.1637 41.4633 -5.36906 3.36653 2.36319 +5784 6 9.96112 23.6102 1.61114 1.89646 0.256416 -8.05524 +5785 4 10.3422 24.1467 0.893187 3.70522 0.0162214 12.766 +5786 4 9.63217 22.8308 1.16111 -2.5861 -8.4474 -3.4617 +5787 6 27.3279 14.1675 11.3384 -16.3978 3.93745 18.7515 +5788 4 27.0565 14.7974 10.6584 -0.154384 0.736593 1.51299 +5789 4 26.9739 14.5213 12.1957 15.9081 -3.44829 -24.7787 +5790 6 25.8416 31.7729 17.8867 -18.6075 -57.137 -13.4601 +5791 4 26.5498 31.1652 17.5816 -7.88637 19.42 8.67928 +5792 4 26.1364 32.6121 18.1157 31.0786 47.9057 11.8145 +5793 6 28.5054 34.3394 0.220618 54.67 33.5077 11.5224 +5794 4 29.0324 33.8757 0.885908 -4.94848 -3.20805 0.921423 +5795 4 27.711 33.8992 0.092994 -46.8158 -31.9819 -6.78258 +5796 6 39.4821 27.6754 22.7241 37.6977 26.8974 -34.7457 +5797 4 38.562 27.8477 22.7631 -35.1425 8.51836 6.28403 +5798 4 39.8483 28.4606 22.2037 -4.4779 -30.5719 17.4824 +5799 6 19.3989 35.5068 37.6449 44.7238 7.00696 26.241 +5800 4 18.7939 34.9286 37.217 -17.2642 -20.3375 -13.2178 +5801 4 20.0787 34.9056 38.0699 -27.4009 15.1777 -18.4057 +5802 6 40.2622 30.2205 10.7395 23.7464 -4.20556 -44.2191 +5803 4 39.872 30.2327 11.5724 -12.5687 -7.32393 56.9787 +5804 4 39.6265 30.6987 10.2193 -5.46151 14.1383 -16.826 +5805 6 44.8252 28.4803 36.0885 -55.5401 -40.4399 48.4955 +5806 4 44.0914 27.9458 36.6324 49.8455 26.3412 -39.6007 +5807 4 44.7386 29.3482 36.4954 11.2485 4.05282 -13.3799 +5808 6 17.9305 13.9374 34.278 5.37655 43.1893 -39.9004 +5809 4 17.3503 14.7126 34.0365 12.4853 -29.216 13.3111 +5810 4 17.5732 13.4499 34.9957 -23.6035 -11.4222 25.4792 +5811 6 22.772 11.7897 25.9182 -5.92321 66.9234 -24.4623 +5812 4 22.4079 10.9608 26.1065 -2.80798 -46.2844 14.8143 +5813 4 23.7282 11.8442 25.9391 13.2658 -20.917 3.34216 +5814 6 27.9678 31.9745 40.3581 9.67064 -3.036 11.5355 +5815 4 28.3415 32.7469 39.952 3.83939 12.9153 -6.44865 +5816 4 27.8423 31.3481 39.6454 -9.64166 -7.41544 0.62615 +5817 6 29.7189 5.14175 29.7003 46.1252 -36.6163 -19.9261 +5818 4 29.2969 5.47215 30.4671 -15.8461 16.6952 32.1509 +5819 4 30.5834 4.69597 30.0017 -39.473 23.5261 -13.8417 +5820 6 3.10812 21.482 2.76797 0.178067 -30.2305 -7.76436 +5821 4 2.88389 22.394 2.68207 -8.68283 21.8462 0.431797 +5822 4 2.52465 20.9987 2.15107 4.11904 7.00085 10.9335 +5823 6 13.6455 30.6616 39.7413 -31.0251 6.24286 -53.6991 +5824 4 14.4958 30.9276 39.9901 40.59 7.52955 18.7737 +5825 4 13.6028 30.9637 38.7781 -13.7388 -14.6365 40.9566 +5826 6 39.1879 23.0833 28.2631 23.8153 34.0131 -40.8644 +5827 4 39.3603 23.1915 27.276 -9.32936 -4.03115 31.7012 +5828 4 38.6771 22.3028 28.3825 -19.3689 -24.2853 3.44718 +5829 6 16.9942 23.7475 0.782551 23.2332 -11.0525 -6.02825 +5830 4 16.1835 23.4907 1.22514 -0.204047 -3.07314 3.44284 +5831 4 17.6924 23.1245 1.11262 -18.9135 18.2649 -2.71213 +5832 6 0.34625 33.6655 13.0265 -29.0282 32.855 38.2597 +5833 4 54.9333 33.1158 13.7076 7.16186 -20.0974 -8.4449 +5834 4 0.196186 34.5312 13.5136 21.864 -23.0202 -35.8666 +5835 6 49.1134 40.6592 16.9502 -22.6074 7.13526 -12.7963 +5836 4 49.0929 41.0585 16.0481 9.95068 -10.3513 11.1088 +5837 4 48.1763 40.6949 17.2078 7.5264 3.31219 -3.37923 +5838 6 52.1371 39.9932 15.179 23.5783 8.13152 6.60826 +5839 4 51.9212 40.0798 16.1068 2.92809 -1.65288 7.91558 +5840 4 51.3496 39.6649 14.7978 -27.1925 -6.99882 -20.2103 +5841 6 29.0492 37.0934 37.8397 27.862 0.580994 -15.5106 +5842 4 29.7824 36.6456 38.29 -13.83 -0.942856 -3.03347 +5843 4 28.3401 37.1923 38.4583 -14.8343 8.34268 17.6028 +5844 6 4.87483 1.47389 27.5722 8.99005 1.78018 0.412076 +5845 4 5.18955 1.04652 26.7639 -2.94161 4.65408 6.15856 +5846 4 5.65876 1.67721 28.1054 -5.69693 -0.488114 1.02013 +5847 6 43.5905 24.3648 30.2005 -22.2044 -15.6763 19.9702 +5848 4 44.3573 23.9419 29.8442 19.8319 -9.6252 -11.3654 +5849 4 42.9995 23.6287 30.4468 4.54232 11.3491 -5.57307 +5850 6 33.7546 3.53169 22.9281 6.20171 -10.3572 -20.5792 +5851 4 34.1788 2.72522 22.5548 -7.61164 22.2296 6.95503 +5852 4 33.66 4.19918 22.2026 -0.715781 -19.232 19.3758 +5853 6 19.8847 13.4579 25.4063 -13.0952 -9.58357 -31.6265 +5854 4 20.5464 14.0819 25.6574 14.0517 10.8301 14.4774 +5855 4 19.8633 12.7253 26.0209 8.35596 -5.88238 10.9252 +5856 6 47.3765 23.175 39.6238 -8.62258 12.6683 8.16714 +5857 4 47.7656 22.5263 39.0394 4.03481 -11.1372 -12.2265 +5858 4 47.7314 24.026 39.3382 2.38196 -1.35255 2.76448 +5859 6 20.1792 18.6695 32.3892 10.8118 -11.8558 9.82813 +5860 4 19.7451 19.3837 31.9609 -18.6549 15.8768 -14.4176 +5861 4 21.1063 18.8885 32.2904 5.57481 -8.22146 4.6255 +5862 6 0.469489 5.80056 25.6694 -18.1951 25.8664 -34.3154 +5863 4 0.192512 6.63022 25.2132 12.4788 -26.9708 -4.90825 +5864 4 0.599388 6.15564 26.5295 8.98284 3.20038 34.2611 +5865 6 6.87796 19.5502 31.9212 -30.9469 28.3562 -15.4034 +5866 4 6.36899 19.9719 32.666 7.94508 -11.3044 -26.1662 +5867 4 6.51823 19.9652 31.058 21.1032 -17.2362 32.6466 +5868 6 6.72006 20.2763 38.5282 -5.5716 11.964 -18.9783 +5869 4 5.89143 20.7831 38.5761 11.8801 -4.42879 -4.55199 +5870 4 6.91977 20.0675 39.4366 -2.33705 -6.77268 4.9945 +5871 6 22.0131 25.9408 12.2669 -3.54377 -45.9259 -44.7125 +5872 4 21.4169 25.4251 11.6232 6.06411 36.0021 36.1209 +5873 4 22.8575 25.5519 12.0003 5.79029 4.70211 8.19546 +5874 6 39.2956 7.94468 2.64777 3.93347 -3.54621 1.69719 +5875 4 39.6192 7.96721 3.55942 2.89932 9.4301 1.57912 +5876 4 39.5223 7.0665 2.33247 5.57505 -8.53159 -3.65477 +5877 6 29.9733 22.0379 34.4029 6.80249 8.99144 -26.5663 +5878 4 30.9486 21.9114 34.4332 -22.6925 2.47334 -4.63229 +5879 4 29.7282 22.2324 33.4511 1.23467 -5.29722 31.1857 +5880 6 37.585 16.2896 0.378862 9.66072 -32.1652 -13.4334 +5881 4 37.1738 15.3958 0.469359 7.4986 19.6703 2.82788 +5882 4 38.3979 16.0784 41.7811 -5.81955 5.34443 7.8674 +5883 6 11.7199 13.8969 21.9024 0.976022 -4.28814 -52.9061 +5884 4 11.762 13.5091 20.9636 8.25344 3.74313 41.2159 +5885 4 11.7301 13.2111 22.5694 -0.197866 -18.3587 0.721586 +5886 6 33.3547 10.9227 27.6206 7.79028 2.98821 -12.2755 +5887 4 32.7398 11.5851 27.2614 8.9286 -8.03905 3.2582 +5888 4 34.0693 10.7866 26.9485 -19.1033 10.7299 13.3482 +5889 6 30.9479 36.5351 10.0985 1.61282 -58.9885 -21.8283 +5890 4 31.0506 36.3975 9.1055 -4.33965 11.8991 35.1417 +5891 4 31.0192 35.5887 10.4601 -6.41155 39.3119 -7.26857 +5892 6 45.5784 6.55949 25.24 49.1938 -13.828 -6.30557 +5893 4 44.6777 6.5515 25.5065 -25.461 -8.09624 7.65514 +5894 4 45.978 5.64009 25.2752 -26.9592 28.1751 -0.0529727 +5895 6 9.53089 30.0259 12.0468 18.203 -29.4993 -35.3826 +5896 4 9.87965 30.5113 11.2809 1.8895 2.86193 6.03312 +5897 4 9.26134 30.6784 12.652 -18.7794 25.6859 27.1844 +5898 6 53.0787 24.9761 1.37462 5.70131 11.5656 52.3682 +5899 4 52.7701 24.171 1.02302 -14.9871 -27.078 -25.8882 +5900 4 53.2426 25.5756 0.676612 4.18045 17.0305 -26.7636 +5901 6 26.1794 24.7359 0.502901 22.1176 -25.6344 -30.1555 +5902 4 25.7034 24.7594 41.5454 1.42755 5.35042 26.0986 +5903 4 25.8798 25.3805 1.12222 -18.0425 21.9232 11.274 +5904 6 23.006 2.41877 11.549 3.03835 0.786733 -23.201 +5905 4 22.1232 2.19651 11.8728 1.75899 -1.65202 1.96434 +5906 4 22.9163 2.42328 10.5701 -3.31062 2.24291 13.1011 +5907 6 29.9286 12.8953 30.9894 2.56623 -0.427284 6.89615 +5908 4 30.7531 12.7948 31.5295 -11.6926 9.48208 -25.7239 +5909 4 30.1452 13.1242 30.0532 3.97045 -7.90132 21.6369 +5910 6 24.0654 16.1863 40.3478 -8.57837 -16.1993 -7.0618 +5911 4 23.8181 16.8167 40.9886 -17.7345 17.1107 43.7161 +5912 4 24.4461 16.799 39.7307 8.03288 -6.21636 -19.956 +5913 6 21.8775 29.9129 12.7438 8.38993 20.3936 0.69825 +5914 4 21.1101 29.6022 12.2761 -16.411 -9.00989 -4.05561 +5915 4 21.7959 30.8814 12.6689 6.66677 -10.3308 5.74649 +5916 6 45.2196 12.276 6.62528 -23.2047 44.1078 30.1736 +5917 4 45.4494 11.529 6.11864 16.0879 -27.9404 -20.133 +5918 4 45.9267 12.944 6.63915 -2.18395 -9.27911 -10.7446 +5919 6 7.59043 25.3914 38.0243 42.7544 -18.087 21.3587 +5920 4 8.2454 25.1294 37.3073 -28.6085 13.3538 22.5553 +5921 4 8.06078 25.1795 38.9036 -17.5445 13.8955 -36.9473 +5922 6 46.1702 7.81994 16.6869 -21.8749 40.0263 -11.2018 +5923 4 46.5308 7.86296 15.7811 2.96678 -6.7279 9.6444 +5924 4 46.6568 7.20863 17.2067 24.29 -27.7199 6.2944 +5925 6 54.9712 12.8519 7.72645 -5.0392 -7.84126 -11.592 +5926 4 54.9715 13.8156 7.65436 -3.45199 -1.13943 9.08655 +5927 4 54.3111 12.5688 8.37934 8.51313 12.0297 -0.864167 +5928 6 26.936 39.6495 37.1759 1.87165 14.912 18.6021 +5929 4 27.6928 39.6002 36.5592 -3.34619 -10.0228 14.3716 +5930 4 27.1866 39.3914 38.108 -0.832196 -0.678219 -33.4669 +5931 6 27.0349 8.92218 38.0169 24.6524 -2.61622 -28.7715 +5932 4 26.316 9.52058 38.1337 -23.9094 17.4181 8.51603 +5933 4 27.4852 9.31616 37.2255 -4.7843 -14.0734 18.554 +5934 6 8.05135 7.65161 29.9116 12.1299 -7.94147 21.2544 +5935 4 8.62851 7.92802 30.6495 -6.35395 -5.29094 -12.0163 +5936 4 7.74814 8.47335 29.5547 -5.2558 18.4649 -14.2469 +5937 6 27.8737 27.8565 12.1051 -38.6038 15.3188 22.9885 +5938 4 27.4445 28.7122 12.3849 14.7215 -19.9621 -4.23437 +5939 4 28.6312 28.0341 11.5799 28.6137 10.9177 -18.1106 +5940 6 23.5548 30.5037 38.1558 -29.4871 -31.9475 26.5081 +5941 4 24.0962 30.758 38.9126 3.93335 7.76671 -5.43794 +5942 4 23.9417 30.8351 37.3772 21.2145 16.4773 -23.4003 +5943 6 48.0793 24.306 17.3344 -19.3615 12.8085 -14.3801 +5944 4 47.2872 24.7421 17.7455 27.359 -7.68532 -3.4425 +5945 4 48.1537 24.7387 16.4546 -0.580236 -6.90317 13.1114 +5946 6 38.498 5.30294 40.3305 40.7021 23.5094 2.62433 +5947 4 38.9475 4.64687 39.7972 -10.9193 -18.4764 2.07144 +5948 4 39.1882 6.01706 40.3225 -28.8653 -3.92995 8.38836 +5949 6 31.2337 3.92695 33.7301 -2.6422 16.6026 -6.87478 +5950 4 31.7948 4.28658 33.0166 -2.97898 -8.44373 7.32517 +5951 4 31.5298 3.03423 33.9266 10.3473 -9.06319 -0.444766 +5952 6 41.2426 8.81864 38.1104 -4.47266 -7.82466 24.3448 +5953 4 41.0373 8.41451 38.9755 -2.01902 1.52645 -10.1427 +5954 4 41.1368 9.75783 38.3095 7.23604 3.04516 -5.74389 +5955 6 53.3619 29.0937 24.5785 -40.2757 11.297 7.14485 +5956 4 52.5565 28.5537 24.7901 26.871 10.2044 -0.818821 +5957 4 52.9453 29.9599 24.3491 20.4755 -15.9472 -3.03 +5958 6 54.9044 15.544 40.7081 25.545 -57.3548 17.1629 +5959 4 54.9892 16.405 40.3633 -12.4948 43.2864 -12.4113 +5960 4 54.018 15.2891 40.9908 -7.57666 14.2468 -5.0348 +5961 6 46.3994 17.0672 31.8767 -6.245 16.1286 -17.5712 +5962 4 46.5114 17.9797 31.5283 3.34232 -11.2714 9.55259 +5963 4 45.8128 16.6602 31.1996 2.74349 5.02824 21.6551 +5964 6 36.898 25.0477 23.0493 11.3229 21.4084 -39.4528 +5965 4 37.2029 24.9737 23.9235 7.13326 -1.42781 43.2733 +5966 4 36.3025 24.3424 22.8486 -15.8402 -9.5757 6.36085 +5967 6 11.3692 4.41343 15.9249 15.7896 22.4119 -17.7964 +5968 4 11.3725 3.62473 15.3598 -3.28732 1.6252 14.2587 +5969 4 11.7055 5.11941 15.3214 -6.01385 -9.48847 12.8461 +5970 6 12.7845 7.07125 19.464 -10.6801 6.56169 22.7508 +5971 4 12.8604 6.27981 18.9655 14.1597 -21.8558 -24.6024 +5972 4 12.2771 6.71627 20.2197 6.8185 19.6013 -8.61559 +5973 6 12.0681 33.6471 17.5522 -1.52085 -17.496 -42.1785 +5974 4 11.9445 34.1189 18.3508 -6.25092 12.897 34.2466 +5975 4 12.5251 32.8183 17.7704 2.9394 6.95993 4.68875 +5976 6 10.2419 4.74292 2.55933 22.7613 10.361 1.71337 +5977 4 9.42389 4.50476 2.9876 -9.73314 -9.75152 7.74431 +5978 4 10.9687 4.12007 2.82053 -14.8261 2.90481 -11.2179 +5979 6 4.58785 36.8771 12.1606 -7.79451 -50.5455 -28.0593 +5980 4 4.4315 37.6675 12.6216 -0.588552 45.9766 17.7929 +5981 4 5.40236 36.9214 11.6472 0.781205 5.58305 7.99313 +5982 6 30.7591 35.3322 25.8391 -38.6972 -6.70904 -25.8809 +5983 4 31.308 35.3014 26.6139 2.09136 -3.6723 11.5509 +5984 4 29.8922 34.8696 26.0006 25.0535 4.09477 3.57125 +5985 6 20.1826 7.15897 1.87495 42.3449 13.1453 -15.8992 +5986 4 20.9155 6.54161 2.14653 -26.0098 16.5163 -6.36728 +5987 4 20.7109 7.92751 1.4772 -24.8109 -25.5601 12.7141 +5988 6 21.7554 6.89613 28.9929 -8.55274 -2.37394 -9.1913 +5989 4 22.0764 7.2366 29.8207 3.60587 3.07422 19.5812 +5990 4 22.5251 6.52709 28.5653 7.82832 -0.878326 -6.51175 +5991 6 6.87782 37.1389 6.94163 -1.13334 10.8563 13.3375 +5992 4 7.36847 37.9928 6.7949 -15.2779 -15.8129 7.53623 +5993 4 6.56156 37.0941 7.87645 12.8328 8.43507 -22.3513 +5994 6 37.1951 18.3599 16.3051 31.8484 54.3956 -63.0636 +5995 4 36.5686 18.6502 16.9278 -28.3708 4.63663 38.6073 +5996 4 37.3394 19.2548 15.8115 -3.93301 -42.965 18.1753 +5997 6 52.3874 25.498 31.3134 14.111 8.09505 3.74503 +5998 4 52.2596 26.4307 31.6656 16.8187 -33.1452 -9.3176 +5999 4 53.3531 25.244 31.2999 -24.6813 13.8962 6.4969 +6000 6 3.93514 39.8328 16.38 27.5969 -10.0907 -6.6773 +6001 4 3.11618 39.8354 16.8714 -5.56329 -11.6849 3.14974 +6002 4 4.25813 38.8985 16.2148 -16.7217 35.1377 3.93655 +6003 6 26.055 14.6352 18.3097 2.48745 23.0231 -5.4837 +6004 4 27.0121 14.5315 18.422 -4.58232 5.3017 0.111087 +6005 4 25.8831 15.6122 18.2324 0.591934 -25.1482 1.36918 +6006 6 22.1861 39.625 23.6336 -13.0035 -7.16992 22.0669 +6007 4 22.5756 40.4198 23.3178 20.0241 20.7615 -16.9022 +6008 4 21.775 39.9577 24.4575 2.36146 -17.5943 -7.81238 +6009 6 5.9827 12.8747 22.3739 5.28791 3.19174 -0.347139 +6010 4 6.16079 13.1981 21.4813 -0.557605 -0.80783 -0.954564 +6011 4 6.85402 12.6686 22.7296 5.64669 -4.60509 -1.11135 +6012 6 48.9358 28.1656 34.7093 -34.12 -15.1013 -7.57113 +6013 4 48.3009 27.4712 34.4428 -1.24475 21.7165 7.07681 +6014 4 49.7483 27.6911 34.6564 33.1581 1.27133 3.59264 +6015 6 7.76665 22.4378 33.2356 5.82113 4.36953 2.134 +6016 4 7.99414 22.0593 34.0982 -2.05459 -3.4103 -7.93698 +6017 4 7.15982 21.8587 32.7652 -2.05153 -2.03416 7.79212 +6018 6 41.0903 39.5994 11.7192 28.8485 25.6095 5.96672 +6019 4 40.6961 40.3697 11.3388 -29.9964 5.48828 -17.7316 +6020 4 41.854 40.0697 12.1081 -2.33823 -21.5528 5.66509 +6021 6 26.8801 37.922 39.3457 -9.67122 -13.15 30.7983 +6022 4 27.1418 37.9976 40.2903 -3.7646 7.48977 -14.0985 +6023 4 25.9915 37.5069 39.4007 11.6973 7.1772 -10.1587 +6024 6 16.8317 41.5399 16.7862 15.0313 6.40425 17.7164 +6025 4 17.5506 0.178386 16.4567 -5.24562 -1.69226 -13.3924 +6026 4 17.0965 41.4441 17.7156 -14.9292 -9.12078 -7.2801 +6027 6 19.02 8.9948 17.6728 1.01249 -20.0254 27.6053 +6028 4 18.8256 9.92734 17.8397 -2.50665 -0.780218 3.94781 +6029 4 19.0722 8.45531 18.5284 1.63313 22.2167 -34.6872 +6030 6 31.0993 24.379 20.1031 -5.45136 7.30173 -0.0135243 +6031 4 30.58 24.6604 20.88 7.69136 -4.59203 -13.2888 +6032 4 31.7465 25.0718 19.9526 0.652083 2.88804 -0.364555 +6033 6 24.6121 6.3117 27.596 -14.2942 3.47042 8.51555 +6034 4 24.6855 6.72112 26.7154 0.000835906 -11.6728 3.52597 +6035 4 24.4562 5.35726 27.5796 2.29956 0.742888 -9.80031 +6036 6 11.6309 5.33579 8.21245 48.3472 17.5789 -13.0214 +6037 4 10.7447 5.097 8.35577 -43.9811 -8.24091 9.59422 +6038 4 11.6324 6.14291 7.66014 -5.62825 -15.0071 6.92232 +6039 6 16.4828 34.2339 17.2467 58.9453 43.3211 -11.1422 +6040 4 15.833 34.737 16.7643 -22.9367 -4.06405 -2.05249 +6041 4 17.323 34.8225 17.0684 -41.083 -49.3458 15.3182 +6042 6 40.7431 40.4645 8.52128 12.2314 -11.8005 -21.5431 +6043 4 40.0246 40.6751 9.09883 -14.9736 5.2464 12.3608 +6044 4 40.4244 39.6664 8.05294 5.87539 10.603 6.78918 +6045 6 42.7463 5.87875 14.2877 12.74 -3.29305 -3.26541 +6046 4 42.0588 5.87807 14.9272 -15.1719 8.11415 20.4154 +6047 4 42.5132 5.11812 13.7588 -0.0411089 -3.23222 -11.0769 +6048 6 14.3659 21.065 6.06718 -46.5802 14.1632 25.7131 +6049 4 14.5381 21.6726 6.80844 -4.55135 -9.99097 -5.53618 +6050 4 15.2049 20.8313 5.76105 45.2018 -10.2131 -22.6687 +6051 6 16.2987 37.772 18.1217 -43.41 26.7654 24.2454 +6052 4 15.4242 38.2299 18.3727 36.2216 -25.3097 -28.3843 +6053 4 16.6845 37.7048 19.001 13.5629 -5.49997 -6.41318 +6054 6 40.7915 27.7152 27.1158 9.45156 2.81801 -4.91689 +6055 4 41.5456 27.319 27.566 -3.53201 -5.16081 10.0516 +6056 4 41.2155 28.2976 26.4751 -4.07016 3.79859 -1.40954 +6057 6 44.9595 25.9846 14.0499 3.3218 -15.4841 -8.79479 +6058 4 45.329 25.1566 13.6433 -5.22711 26.2877 13.1546 +6059 4 45.4837 26.7406 13.7529 4.37393 -9.76715 -6.45081 +6060 6 2.62066 33.9505 21.2427 -16.9582 -3.86849 -3.69815 +6061 4 2.06211 34.7496 21.3041 9.37305 -3.74186 4.79914 +6062 4 2.1388 33.3568 20.6382 5.47892 10.3925 4.65279 +6063 6 5.77806 4.43691 12.8378 4.70319 28.9306 -8.8144 +6064 4 5.36233 3.72198 13.3221 -5.81749 -8.58488 4.20714 +6065 4 5.80863 5.24637 13.3804 -1.3041 -13.5761 2.8333 +6066 6 16.8665 5.92021 7.40582 23.56 -3.08178 3.03829 +6067 4 16.4354 5.08697 7.20958 -2.89912 -12.7512 -7.28137 +6068 4 16.1638 6.54304 7.4701 -21.737 13.5702 4.65232 +6069 6 17.8259 38.4084 36.8446 -8.45971 28.6621 19.1884 +6070 4 17.7005 39.3712 37.0468 11.155 -18.7052 -15.1769 +6071 4 18.5325 38.3077 36.2071 4.43545 2.51623 -4.89916 +6072 6 43.3084 20.5973 5.4325 -39.7754 20.35 -2.23031 +6073 4 43.0204 21.5105 5.15286 19.9417 -23.843 3.70329 +6074 4 42.4274 20.1471 5.43024 22.0601 -2.53082 1.71294 +6075 6 21.5318 23.3 30.4444 10.3709 20.0389 -42.3415 +6076 4 21.0369 22.9394 31.1576 -20.9289 -4.03021 22.2109 +6077 4 20.911 23.6578 29.7428 10.7798 -15.246 22.7192 +6078 6 0.249866 28.0345 36.1724 -10.1983 37.6035 -27.6546 +6079 4 1.05324 27.7572 36.576 20.3102 -14.8665 16.9966 +6080 4 0.540234 28.832 35.6712 -10.982 -12.5736 6.41543 +6081 6 3.04754 17.0516 11.5683 -6.97145 7.64509 -15.3824 +6082 4 3.16434 17.3061 12.4746 3.36597 -0.550097 20.9912 +6083 4 2.52404 17.7798 11.2137 2.91457 -3.72579 -4.7217 +6084 6 24.1788 37.0366 23.9551 -12.9856 4.64226 12.2764 +6085 4 23.6099 37.826 23.831 6.85326 -8.75197 5.00341 +6086 4 24.4012 36.9865 24.9175 -1.53567 3.17074 -21.6248 +6087 6 3.95494 20.5134 27.4915 2.8093 53.7214 17.1103 +6088 4 3.58105 20.0931 26.7551 -14.7022 -26.8908 -38.8522 +6089 4 3.8118 21.4686 27.2477 5.25372 -20.6261 11.8203 +6090 6 54.8404 2.77723 29.6182 19.2518 19.5174 31.7291 +6091 4 54.8688 2.43537 30.559 -2.71579 12.5717 -24.6672 +6092 4 0.596183 3.44189 29.5911 -17.1059 -25.2514 0.407437 +6093 6 27.1931 8.41834 31.7378 -5.45838 77.4793 -29.1542 +6094 4 26.7872 8.25949 30.8671 -2.01983 -12.8877 1.93898 +6095 4 27.4107 9.43311 31.6496 -7.24897 -56.0438 21.5563 +6096 6 30.967 1.65521 30.3853 -24.4372 0.252197 19.6085 +6097 4 30.699 0.824835 30.0215 -2.04196 -23.8902 -26.6583 +6098 4 30.1085 1.94064 30.7387 6.28416 6.26069 6.0985 +6099 6 26.4053 36.4472 36.8445 23.7132 4.61357 6.55265 +6100 4 26.2095 35.8808 36.1068 -5.45287 -5.64468 -12.8873 +6101 4 27.3732 36.593 36.8324 -14.4493 2.44748 -3.93886 +6102 6 51.2993 10.0458 21.7014 24.6671 -30.2423 2.93053 +6103 4 50.7417 9.318 22.0589 9.26734 22.884 -6.07289 +6104 4 52.1551 9.59094 21.4448 -31.6711 18.7199 5.84467 +6105 6 52.4308 12.3792 23.2584 -6.42579 27.1004 22.8118 +6106 4 51.6946 13.0394 23.3088 16.6887 -7.91574 -6.77392 +6107 4 52.0327 11.5757 22.9611 -11.4365 -20.1199 -14.9439 +6108 6 9.99751 38.3699 20.6117 28.0449 -1.18219 -11.795 +6109 4 9.42862 38.2366 21.3654 -6.81781 0.619005 12.6857 +6110 4 10.9196 38.1916 20.8926 -11.789 -1.89114 -3.31064 +6111 6 22.7111 33.2651 0.632604 -8.26324 25.0772 17.5737 +6112 4 23.6702 33.3984 0.628432 0.752102 -10.2993 -4.51528 +6113 4 22.4939 32.4115 0.275412 2.14165 -18.6843 -11.1325 +6114 6 14.0859 40.8716 25.4956 -8.46488 1.55142 -11.4693 +6115 4 14.0599 40.7138 26.4427 12.1567 0.227551 5.06398 +6116 4 13.2623 40.45 25.1949 6.8133 8.32038 -2.55804 +6117 6 42.7734 15.0947 14.9538 14.4784 5.50426 -3.8277 +6118 4 43.0583 15.7694 14.2817 -8.42225 -24.0175 22.033 +6119 4 41.8405 15.2241 15.1238 -9.70916 3.613 0.791575 +6120 6 30.2327 7.231 8.54228 -3.22532 10.2874 -46.9304 +6121 4 30.2058 8.2102 8.45082 -0.363858 -13.9116 11.7844 +6122 4 30.4404 6.92219 9.39771 6.32383 2.81905 38.5597 +6123 6 3.37293 19.847 41.3038 28.0406 -0.792001 0.268463 +6124 4 3.19157 19.2836 40.5407 -0.0866071 4.98821 -2.30354 +6125 4 4.34764 20.0104 41.227 -24.6382 -4.50526 4.46777 +6126 6 8.87233 25.1482 17.2024 12.9182 -25.3276 -29.7935 +6127 4 8.99656 24.7585 16.2934 -10.9438 23.5455 20.5923 +6128 4 9.70028 24.8859 17.6216 -4.47076 0.166054 9.91948 +6129 6 9.34357 14.9539 22.0324 -26.1912 3.45279 3.87325 +6130 4 9.00509 14.8035 22.9321 4.97494 4.93375 -7.4516 +6131 4 10.1685 14.4775 21.9786 8.71262 0.391972 2.49596 +6132 6 2.03472 4.77693 20.8549 -5.0231 -16.4156 -4.2241 +6133 4 2.70086 5.4497 20.9192 18.9425 7.91266 2.94425 +6134 4 1.28907 5.15394 21.3146 -15.2358 3.90158 4.43282 +6135 6 18.286 7.04631 3.85489 -3.97091 0.415968 51.7005 +6136 4 18.7541 7.10917 3.04736 31.918 9.65669 -29.8899 +6137 4 18.8529 6.48913 4.44789 -12.6499 14.6692 -9.5202 +6138 6 17.0004 19.1661 19.8445 11.8294 -6.56912 -12.2376 +6139 4 17.7808 18.891 19.3473 0.445698 5.6808 3.33406 +6140 4 16.3387 18.5282 19.5337 -1.78106 12.0244 12.6463 +6141 6 4.30992 6.55322 21.357 27.1319 -4.11604 -15.0588 +6142 4 4.37542 6.91771 20.4543 -7.8574 5.76294 11.3657 +6143 4 5.24976 6.29093 21.5457 -28.1422 4.34799 0.417434 +6144 6 20.7778 36.9247 35.6618 12.7574 4.02765 2.49936 +6145 4 20.2864 37.0887 34.8562 -7.2468 0.0429553 -2.15645 +6146 4 20.2346 36.372 36.2389 -2.87094 1.27188 3.61263 +6147 6 4.73067 15.0203 31.2359 -10.2649 -12.7571 22.9725 +6148 4 4.37694 14.8342 32.1428 11.1861 -2.73027 -21.4712 +6149 4 4.72677 15.9733 31.1768 1.84417 11.2425 -7.2724 +6150 6 2.35535 1.23403 17.5726 17.2813 12.9738 -21.7174 +6151 4 3.03402 1.36527 16.8495 -17.2186 -13.1695 22.3246 +6152 4 1.92973 2.10387 17.6452 0.590267 -7.80147 9.6411 +6153 6 34.6252 31.5686 19.7984 -1.60729 -4.66139 0.568696 +6154 4 34.8929 31.9422 18.9439 4.49305 -5.18782 4.12596 +6155 4 34.4714 32.3271 20.3758 -2.9002 2.23803 -3.07041 +6156 6 24.1913 21.6089 13.5036 44.4004 0.328862 15.9674 +6157 4 25.0757 21.8297 13.9142 -30.8821 -6.11275 -18.7564 +6158 4 23.5519 22.0563 14.035 -11.4749 15.2668 7.23318 +6159 6 37.218 41.0972 5.69166 19.5034 -37.5651 -15.7416 +6160 4 37.88 41.7374 5.923 7.59407 13.6828 5.23653 +6161 4 36.3807 41.3769 5.99879 -24.6171 21.3167 5.70938 +6162 6 8.42841 7.99247 20.2345 27.9918 -33.0924 -23.0682 +6163 4 9.34968 8.06233 20.5347 -4.8675 5.92304 8.61954 +6164 4 7.93058 8.66586 20.633 -20.9635 39.4709 23.1164 +6165 6 14.934 18.8758 36.75 17.7625 18.3313 11.0559 +6166 4 14.0949 19.1945 36.41 0.856939 4.31409 -3.77921 +6167 4 15.6034 19.6084 36.7133 -18.5855 -12.9909 -4.44137 +6168 6 43.9791 40.6449 18.6524 7.41508 -0.428335 24.9958 +6169 4 43.9624 40.7544 17.7052 -3.16787 6.2189 -16.8328 +6170 4 44.8981 40.8188 18.9384 -9.62798 -9.77666 -5.30663 +6171 6 33.7986 32.259 37.3472 -15.5926 9.65631 -28.1821 +6172 4 34.0274 32.2295 36.4014 -5.19534 3.83485 15.8105 +6173 4 34.1945 31.4931 37.7276 18.2887 -12.3889 13.4194 +6174 6 5.09973 29.2834 24.0252 13.8314 -2.01249 29.2407 +6175 4 5.66693 29.5091 24.8044 -5.06459 -6.54793 -18.8628 +6176 4 4.76417 30.1245 23.7257 -5.49348 12.2693 -6.11875 +6177 6 33.6015 36.4179 10.971 30.294 2.53226 6.78363 +6178 4 32.7735 36.2836 10.5343 -15.5054 6.45725 -2.01925 +6179 4 33.4383 36.5424 11.9099 -7.56878 -2.98124 3.33663 +6180 6 28.3001 33.6166 13.1114 -3.16981 -41.1231 7.22112 +6181 4 27.986 33.7275 12.219 -4.10441 9.98298 -8.29397 +6182 4 28.0891 32.6746 13.2632 10.0083 14.4728 2.55385 +6183 6 6.1623 19.0624 24.2873 5.31394 -11.2621 -36.8053 +6184 4 5.95503 19.8074 24.8143 -4.51254 28.8134 22.7686 +6185 4 6.28788 18.3114 24.8476 4.1007 -18.6743 20.2695 +6186 6 28.4211 19.9362 1.86305 -4.43245 7.71948 8.08869 +6187 4 28.5604 19.4518 1.05094 6.94613 -11.0067 -8.65768 +6188 4 29.2593 20.0693 2.30859 5.46778 1.78077 -4.74455 +6189 6 42.0505 23.9714 9.55892 6.22877 26.0941 -5.00732 +6190 4 42.391 23.8165 10.4395 -2.03908 -8.00084 11.8727 +6191 4 41.7886 23.1541 9.15249 -7.7641 -22.6922 2.79783 +6192 6 43.5253 7.315 27.4414 4.48568 -18.9578 -0.168547 +6193 4 42.7359 7.07504 27.9388 -6.2009 1.74131 6.88183 +6194 4 43.2052 7.88335 26.7439 -2.31843 16.2411 -9.46916 +6195 6 20.4956 32.9945 9.25625 -63.2008 -2.41398 62.3431 +6196 4 19.7614 32.7323 9.96384 46.0698 -1.29529 -42.5223 +6197 4 20.3338 33.9485 9.24422 8.88758 3.29294 -12.4302 +6198 6 38.0318 35.2729 15.9427 -5.10059 -23.3836 -5.94715 +6199 4 37.3995 34.9842 15.2568 2.89047 3.01243 8.00796 +6200 4 37.9835 34.6007 16.6396 -2.13864 4.37071 -5.14357 +6201 6 47.5248 20.8808 3.95546 13.1177 31.1209 27.8573 +6202 4 48.0834 21.3954 3.36869 -6.69878 -8.89675 -13.1919 +6203 4 47.6052 21.4353 4.7772 -13.2785 -23.1226 -13.8569 +6204 6 10.9875 31.6892 41.4239 15.5099 5.40423 7.74084 +6205 4 11.658 31.8708 40.7529 -4.12469 -5.30401 -0.84079 +6206 4 10.1343 31.6927 40.9879 -7.96504 0.77506 -5.12071 +6207 6 43.245 12.6563 2.56138 15.9633 -17.8577 -2.60545 +6208 4 42.9226 12.9752 3.38765 -12.1061 12.2594 19.7928 +6209 4 43.9805 12.0851 2.8659 -6.2276 8.95994 -12.8364 +6210 6 49.4104 25.4124 21.1593 7.68799 -7.2912 5.83542 +6211 4 50.1422 25.2884 20.5387 -8.96396 0.548785 -4.3756 +6212 4 48.9554 24.5515 21.2297 -0.219253 8.20777 -2.75058 +6213 6 1.96484 34.1377 26.4635 6.42117 -7.58108 12.8955 +6214 4 2.78995 33.6488 26.6876 -20.6965 7.00883 -11.752 +6215 4 1.22498 33.5087 26.4121 8.61724 -1.18295 0.134997 +6216 6 17.1337 20.8362 36.6743 -37.6695 15.6036 21.8376 +6217 4 16.9634 21.7284 37.0778 2.65776 -21.0237 -14.9647 +6218 4 18.0617 20.7108 36.604 32.6572 -5.60583 -3.13187 +6219 6 36.5992 10.9735 3.70439 10.6975 8.82737 -5.2901 +6220 4 35.7369 11.4094 3.76988 -2.71865 -0.136466 14.5734 +6221 4 36.9547 10.7712 4.57736 -11.0261 -1.49358 9.11508 +6222 6 14.2213 20.6732 21.973 14.9521 39.3927 -42.8738 +6223 4 13.9206 20.2439 21.1689 -11.1282 -8.72354 1.45028 +6224 4 14.6851 21.4628 21.5779 -7.13343 -24.0966 22.8635 +6225 6 33.9052 12.2539 9.56536 64.6676 -19.1083 -72.943 +6226 4 34.3898 11.482 9.88615 -11.1791 5.59008 13.1859 +6227 4 33.2619 12.5422 10.1406 -48.1209 12.4396 55.8498 +6228 6 21.8075 41.4938 2.15247 -4.53434 0.170379 -15.7872 +6229 4 22.04 41.6038 1.2069 -3.47083 0.972349 16.0219 +6230 4 22.4007 40.8419 2.51679 12.4955 -1.6466 3.58022 +6231 6 20.9241 10.4413 14.2084 23.7182 11.537 17.3335 +6232 4 21.6155 10.8692 14.7979 -25.0251 -17.572 -17.464 +6233 4 20.772 9.54041 14.5736 6.4121 16.6732 -7.22543 +6234 6 6.25992 4.45494 24.6446 -20.993 10.5392 9.58783 +6235 4 6.70633 4.20365 23.8452 17.869 -10.7134 -15.0213 +6236 4 5.71116 3.71075 24.9084 -2.77077 -5.20552 -8.90983 +6237 6 50.776 14.5967 23.4784 31.7068 8.96229 10.5861 +6238 4 51.3012 15.0259 24.1918 -10.5702 -1.89466 -14.6802 +6239 4 49.902 14.4731 23.8252 -15.4415 -8.6063 7.51113 +6240 6 52.7906 13.9066 9.67243 -4.11462 48.2741 -4.64476 +6241 4 52.8606 13.0389 9.99278 3.823 -46.6932 12.5875 +6242 4 51.8698 14.0585 9.47707 -15.983 -0.946523 -10.048 +6243 6 9.04475 2.0467 29.9184 -38.5307 -30.621 -19.1189 +6244 4 9.46565 2.82007 30.2002 17.3321 39.2201 17.0183 +6245 4 8.08016 2.26538 29.8177 25.0495 -3.86709 2.38687 +6246 6 7.14389 29.9898 26.2407 4.70582 -42.771 12.4286 +6247 4 6.53112 30.404 26.8495 -5.08686 4.52864 3.1398 +6248 4 7.41427 29.1442 26.7142 -2.42767 26.6911 -17.7681 +6249 6 49.1638 41.7413 14.3375 -4.64089 27.4779 2.19815 +6250 4 49.5241 41.3828 13.5134 1.94418 -6.50091 1.47491 +6251 4 49.3811 0.802946 14.3236 2.14399 -30.2019 -5.07663 +6252 6 5.64888 3.82667 19.1906 -2.72189 -11.1411 26.1263 +6253 4 5.18678 3.36179 19.9258 5.23606 10.5823 -14.7259 +6254 4 5.05621 3.82399 18.4509 -7.60985 1.79477 -11.7277 +6255 6 9.32681 35.8274 24.8975 3.55565 13.5922 8.51546 +6256 4 10.2018 35.8152 24.4762 -3.06017 -4.39849 2.56743 +6257 4 9.46171 36.417 25.6586 -3.66837 1.49938 -3.23358 +6258 6 53.0285 29.7558 11.5499 -7.83487 -2.48558 9.64451 +6259 4 53.3653 30.4407 10.9686 7.5475 4.44921 -4.95089 +6260 4 52.7971 30.2083 12.3783 3.5824 -3.07517 -4.75195 +6261 6 22.6104 9.96627 5.67467 11.8622 1.90434 48.3765 +6262 4 23.3836 10.3266 6.15809 -8.36646 -10.9093 -7.81297 +6263 4 22.6398 10.3769 4.83333 -6.21393 7.91547 -32.804 +6264 6 39.5293 19.6134 2.67969 28.3515 9.20962 14.5311 +6265 4 38.5781 19.5068 2.58618 5.24604 -11.8744 -9.9137 +6266 4 40.0367 19.3939 1.87869 -17.6459 -1.04308 -3.70363 +6267 6 45.0742 35.5802 7.80399 12.9966 -1.00157 -13.6899 +6268 4 45.1073 36.2582 8.46111 4.45786 22.5875 10.9896 +6269 4 44.5296 34.9182 8.21469 -15.7495 -15.8794 0.100297 +6270 6 29.7829 14.2459 9.96531 -11.2509 -10.5838 -6.95263 +6271 4 30.0063 14.1556 9.0247 4.7074 -2.26926 1.20969 +6272 4 28.8478 13.9409 10.004 20.3358 11.6689 4.42407 +6273 6 29.2532 30.1489 21.8872 -22.7358 8.41186 19.7293 +6274 4 29.1261 30.8351 21.2312 3.02893 4.58934 -9.48892 +6275 4 30.0577 29.6729 21.7506 17.9631 -9.68935 -13.2514 +6276 6 11.1028 18.8149 6.56446 12.6172 11.1172 -5.75863 +6277 4 11.2898 19.7306 6.3073 -12.9819 2.38317 -1.53669 +6278 4 11.9922 18.4416 6.57196 0.724871 -8.7617 2.86424 +6279 6 13.403 39.1446 13.4748 19.5871 -11.9429 -30.0571 +6280 4 13.7697 39.8507 13.9939 7.8117 10.5151 13.4831 +6281 4 12.6292 38.8582 13.9386 -20.2152 -7.12839 8.32373 +6282 6 50.1432 12.9893 0.138872 33.4511 24.3017 64.4039 +6283 4 49.8497 12.6921 41.2405 -20.6967 -26.8999 -59.7452 +6284 4 50.7523 12.3231 0.503203 -9.52656 2.062 -3.94446 +6285 6 47.8312 31.3446 27.7846 -28.8076 12.8422 -13.2841 +6286 4 47.8833 31.94 28.5222 10.4006 4.03183 17.8143 +6287 4 46.9755 31.6479 27.4044 17.0933 -18.1054 -4.43643 +6288 6 27.7087 1.63781 7.50008 21.5285 -7.57238 -25.6841 +6289 4 26.9556 1.59549 8.05597 -25.0455 5.22958 17.9803 +6290 4 27.5166 0.963037 6.82134 -2.90509 7.89899 -0.0646572 +6291 6 54.8922 20.8 16.0331 4.1789 -41.4982 -7.93337 +6292 4 54.9282 20.9554 16.9716 0.186425 8.83729 15.9831 +6293 4 0.211633 19.8495 15.948 -9.91253 29.0383 -5.43741 +6294 6 37.4291 33.0056 34.4398 -14.0977 10.8622 -7.94924 +6295 4 37.2978 32.0826 34.6133 -1.58878 -21.6351 7.1631 +6296 4 36.5764 33.2755 34.0173 17.7258 4.45123 10.3439 +6297 6 19.5104 39.7742 6.7506 5.90241 -38.4201 -4.61078 +6298 4 19.1293 39.2182 6.01225 10.8403 19.9531 16.5545 +6299 4 19.9162 39.0938 7.35425 -12.9804 24.3225 -11.3083 +6300 6 32.4399 2.72699 8.06906 17.0773 23.4006 1.78158 +6301 4 32.9347 3.14941 8.81642 -19.9733 -16.2934 -9.37408 +6302 4 31.5531 2.49842 8.37658 0.516726 -6.41942 5.39598 +6303 6 12.9757 16.0915 4.06618 3.48233 -26.1302 -11.2272 +6304 4 12.5744 15.6527 4.83433 -0.695682 4.00385 -3.98901 +6305 4 13.3513 15.3473 3.55621 -4.30287 11.2057 5.6128 +6306 6 4.64677 29.9233 5.42983 -10.8182 14.2385 -56.8973 +6307 4 4.99957 30.1958 4.52107 -6.90737 -7.02982 36.161 +6308 4 3.86081 29.3683 5.18005 29.0195 11.7205 17.0104 +6309 6 29.7541 32.1122 24.0662 13.5325 13.0696 7.67536 +6310 4 30.657 32.2311 24.4313 -14.6232 -5.62961 -5.85099 +6311 4 29.8358 31.5529 23.3009 -2.99915 -14.1964 -7.88188 +6312 6 11.8689 30.6971 33.4711 -8.01032 -39.2081 28.7873 +6313 4 11.8961 29.8478 34.0479 -0.904256 41.1124 -29.4381 +6314 4 12.7288 30.7703 33.0546 6.62137 -3.78113 1.33903 +6315 6 17.3676 40.4123 27.3051 45.9752 30.8726 -27.1152 +6316 4 17.3095 41.3718 27.4557 -2.78012 -6.90788 -0.219066 +6317 4 16.6513 39.9873 27.6906 -54.0346 -15.2197 27.4879 +6318 6 8.66734 4.89901 8.93063 6.14116 -5.58058 -4.6479 +6319 4 8.35347 5.40804 8.18272 -1.2331 1.82325 -6.13974 +6320 4 8.16334 5.22925 9.67691 0.199365 1.34734 7.84993 +6321 6 39.5604 17.6833 9.57201 22.5105 -50.1639 -23.667 +6322 4 39.2658 17.6048 10.464 -10.5204 8.51393 23.2154 +6323 4 39.725 16.7168 9.31019 -10.6666 45.7312 -1.86495 +6324 6 31.4955 30.1755 28.5516 10.628 -19.507 17.1882 +6325 4 32.3525 30.3948 28.1778 -6.71462 8.32315 -8.11857 +6326 4 31.74 29.3729 29.0438 -14.9082 5.37925 -0.357203 +6327 6 52.6685 19.2672 40.0663 9.25056 16.4026 -20.0757 +6328 4 53.0106 18.7322 39.321 -9.61724 -4.6138 17.4516 +6329 4 53.0677 20.1385 39.8955 -5.74465 0.792691 -1.74468 +6330 6 3.24164 7.81666 9.85998 28.0429 9.66948 1.15728 +6331 4 3.83019 8.53432 10.2304 -23.9275 -17.8293 -12.7584 +6332 4 3.84853 7.29279 9.3074 -9.38214 5.4782 3.90821 +6333 6 23.129 35.218 35.5945 -25.4929 1.01472 15.9258 +6334 4 23.7784 35.3391 34.9359 33.2897 3.00284 -24.4901 +6335 4 22.5015 35.9398 35.4197 -4.85807 -5.03855 8.29984 +6336 6 19.51 14.0653 20.8221 -35.7596 -3.44758 -1.61502 +6337 4 19.8587 14.4985 21.6011 13.4146 6.44294 7.16022 +6338 4 18.5274 14.0852 20.9637 18.4505 -1.93413 -5.69736 +6339 6 23.6205 15.8624 24.0207 6.44012 -27.6666 -1.73497 +6340 4 23.7023 16.8084 24.0387 5.71305 22.1977 -2.17526 +6341 4 24.4604 15.4749 23.6823 -15.4387 15.2983 3.34328 +6342 6 0.280487 30.496 6.10097 2.10248 14.5258 38.6463 +6343 4 54.969 30.1752 5.28655 -5.78718 -18.1599 -43.8305 +6344 4 54.4568 30.8162 6.51538 2.11893 2.60892 6.09244 +6345 6 4.88818 13.213 29.1211 -10.1066 -44.834 -24.7823 +6346 4 4.81121 13.8494 29.7943 -5.77674 34.7781 35.8081 +6347 4 5.65875 13.4519 28.6173 14.302 5.76116 -10.624 +6348 6 54.2113 27.2762 19.1921 -15.5686 -30.3542 31.9917 +6349 4 0.068746 27.3681 19.6083 11.8738 0.793184 4.88761 +6350 4 54.2438 27.8077 18.4285 0.565084 22.1088 -37.313 +6351 6 13.9147 35.7477 9.19539 -9.45761 -42.0549 -30.4782 +6352 4 13.6498 35.0288 8.53341 12.0253 23.1831 27.3793 +6353 4 13.9217 36.5134 8.63033 3.91359 16.7787 -6.83247 +6354 6 5.91895 31.9062 18.8199 -10.5522 26.6577 -12.1166 +6355 4 5.59368 32.8276 18.7738 -3.70357 -9.82177 15.0022 +6356 4 6.3357 31.8271 17.9661 5.53766 -12.0386 -9.76018 +6357 6 5.80079 28.8629 9.48582 -4.23387 2.66619 -7.91216 +6358 4 5.1492 29.3316 10.0156 -4.194 3.81529 3.65919 +6359 4 5.26808 28.2356 8.96551 5.75879 5.11243 0.385299 +6360 6 40.1186 6.06288 9.7252 27.6823 -14.9678 -34.8134 +6361 4 40.0604 6.61837 8.91786 -4.97866 -6.72317 19.9534 +6362 4 40.8451 5.41953 9.46609 -26.5422 19.2978 14.9684 +6363 6 20.3249 13.4665 41.4109 48.5393 0.491453 -34.6424 +6364 4 21.248 13.7047 41.7262 -35.6043 -9.97545 -2.58991 +6365 4 20.4078 13.625 40.4256 -17.6073 -2.89865 23.6593 +6366 6 14.4355 21.7431 27.3521 26.8888 -5.93952 12.1752 +6367 4 15.3929 21.7238 27.5426 -15.4302 4.65814 3.66232 +6368 4 14.4086 21.5632 26.4128 -6.38145 3.02673 -3.91912 +6369 6 38.7552 1.80385 30.0529 11.0268 -28.3612 -27.359 +6370 4 38.4475 1.96331 30.9218 -11.1335 10.8767 32.3314 +6371 4 38.864 2.66369 29.6567 5.01485 14.1269 -3.82072 +6372 6 5.6038 10.8537 14.1812 -8.02182 -19.6512 10.0037 +6373 4 4.967 11.5707 14.1035 -3.71772 1.30399 -2.93081 +6374 4 5.11243 10.0991 14.6 11.6474 17.9462 -13.8385 +6375 6 45.4185 36.7135 27.9228 -18.8199 18.417 -42.2307 +6376 4 46.0687 36.7087 28.6222 8.21134 6.27257 3.16342 +6377 4 45.7172 37.2784 27.1471 -3.80026 -24.227 32.4306 +6378 6 54.0799 35.0377 20.3974 -0.144446 0.236923 -11.8112 +6379 4 53.8476 34.1116 20.536 0.519878 -4.41527 -2.37245 +6380 4 53.9532 35.2077 19.4441 0.866973 -0.817495 13.7238 +6381 6 42.0671 14.221 28.4749 -2.16655 -3.30611 3.54679 +6382 4 41.9442 13.9043 29.3971 9.00113 8.16851 -11.079 +6383 4 42.9986 14.4434 28.31 -2.56617 -4.72525 9.98454 +6384 6 34.845 7.68802 26.7053 1.50556 20.2543 7.34306 +6385 4 35.7046 7.39142 27.0344 -1.60005 -9.47728 3.59716 +6386 4 34.4934 7.05976 26.0702 4.4346 -10.8207 -3.70702 +6387 6 49.6605 30.7141 23.8514 -28.5275 -6.56067 -11.9374 +6388 4 50.4604 31.1934 23.8565 34.1351 17.5516 -0.640456 +6389 4 49.8146 29.9659 24.4072 5.37992 -19.8924 15.651 +6390 6 50.8948 7.80148 14.1671 21.5777 -12.9452 34.2787 +6391 4 50.8247 6.96775 13.7105 -4.99079 -12.0182 -18.7136 +6392 4 50.5655 8.51894 13.6572 -15.7049 17.9748 -24.3233 +6393 6 4.26893 39.4826 27.8512 8.9926 -8.51629 -1.47833 +6394 4 3.65831 40.2241 27.8513 -3.04259 7.34368 5.94949 +6395 4 4.00328 38.958 27.1013 -12.9816 -10.5728 -11.1653 +6396 6 8.75177 32.8341 8.22283 -21.5639 -30.1985 -34.1316 +6397 4 8.2383 32.1284 7.72694 10.6374 17.547 21.6449 +6398 4 8.83279 33.5372 7.56693 3.76401 9.53239 7.06969 +6399 6 52.9594 25.4882 9.38297 -25.0802 50.1357 20.0056 +6400 4 51.9882 25.4292 9.65119 35.7509 1.27265 -17.7678 +6401 4 53.158 26.4759 9.49827 -6.53976 -44.9947 -5.62964 +6402 6 29.5661 36.7256 19.4603 5.44621 -17.3757 32.4066 +6403 4 29.5786 37.3961 18.7906 9.88328 7.74732 -15.4263 +6404 4 30.4565 36.6309 19.8726 -14.3545 4.38723 -10.5986 +6405 6 52.3236 36.1013 25.1169 17.8415 -25.8683 -35.0149 +6406 4 52.9656 35.7372 25.71 20.0999 5.67458 7.00157 +6407 4 51.6595 36.4261 25.6714 -35.904 19.3861 23.0835 +6408 6 21.182 15.7103 31.1872 -18.8583 3.19523 -20.0756 +6409 4 20.6533 16.2005 30.5215 19.2403 -4.60119 13.454 +6410 4 20.518 15.2243 31.6931 2.46505 1.20146 2.10658 +6411 6 10.6569 22.4337 39.4531 2.51655 -26.4213 -37.4968 +6412 4 10.8327 22.4219 38.4645 -4.29248 9.16844 28.2769 +6413 4 10.2506 21.5589 39.6181 7.08653 12.2011 0.686531 +6414 6 25.1113 11.6729 22.7164 -12.9971 -0.576423 -18.0399 +6415 4 25.1382 11.4787 23.6279 21.2779 0.00518046 39.517 +6416 4 24.1824 11.5118 22.5586 2.84555 -0.272219 -17.8246 +6417 6 31.7896 10.4703 2.90217 -23.2712 -10.1944 -9.79051 +6418 4 32.6146 10.7499 3.28348 13.8778 6.97942 -8.99307 +6419 4 31.8394 10.4464 1.92418 10.0551 5.29594 18.2662 +6420 6 52.4849 36.4361 22.1663 -9.62786 -33.6069 5.21212 +6421 4 53.146 36.0606 21.5474 -12.5852 0.946736 4.3316 +6422 4 52.0694 35.6392 22.6209 17.7505 30.3514 -16.202 +6423 6 46.2093 40.0329 26.9877 0.0297183 29.9961 33.6049 +6424 4 46.4751 39.2742 26.5126 9.55695 -26.8643 -22.4205 +6425 4 45.9048 40.7092 26.3771 -3.76152 -2.91476 -3.34389 +6426 6 24.0885 36.7218 39.1011 7.12362 -3.16907 -4.80429 +6427 4 23.5999 35.9078 38.9667 11.8985 -11.6148 -5.9332 +6428 4 23.4559 37.2234 39.5891 -11.7402 16.6095 17.3029 +6429 6 22.3514 7.42547 31.8169 -35.2707 -41.8068 15.3628 +6430 4 22.2213 8.33277 32.0647 5.94025 21.3422 4.40196 +6431 4 21.6465 6.92073 32.3398 32.1745 21.6054 -24.7594 +6432 6 14.3502 18.3597 4.09728 -2.0055 -9.38358 23.348 +6433 4 14.1099 17.4219 3.93107 -0.92654 19.6042 10.3569 +6434 4 14.0726 18.5364 5.03654 13.0175 -10.3464 -23.9346 +6435 6 27.3175 38.46 0.124188 33.1007 -9.911 1.68747 +6436 4 26.9395 39.2806 0.463932 -4.88512 2.40457 5.81864 +6437 4 28.2608 38.413 0.45438 -35.2324 2.96259 -2.16122 +6438 6 18.6695 0.162292 12.2239 -43.166 1.81748 26.3235 +6439 4 17.7303 0.262878 12.5713 26.4571 2.30278 -22.2908 +6440 4 18.9433 41.3202 12.7499 8.63834 -11.46 6.42912 +6441 6 49.423 24.9792 25.3382 20.605 1.42964 -0.346179 +6442 4 48.5484 24.7002 25.6009 -12.613 -0.556076 -3.92373 +6443 4 49.3508 25.8032 24.8352 -9.8769 -5.62219 -3.2466 +6444 6 52.0685 20.2858 15.7446 -45.9435 -8.75518 14.7384 +6445 4 52.9731 20.5149 15.783 39.268 6.79994 2.42829 +6446 4 51.7449 20.2597 16.6676 4.81444 3.79951 -9.92674 +6447 6 49.6576 15.6472 38.4942 19.425 -17.6129 -0.00729052 +6448 4 49.2099 16.0165 37.7231 -6.98596 1.36616 -1.50856 +6449 4 49.5102 16.1958 39.2633 -14.7214 13.7889 5.58845 +6450 6 15.9211 23.7235 13.4193 23.3289 -36.8815 11.3263 +6451 4 16.506 23.7025 14.2147 -19.633 8.70021 -19.3267 +6452 4 15.5217 24.5725 13.2813 -7.62789 19.6624 11.7876 +6453 6 14.3566 29.1635 14.3074 -12.0826 22.9902 -11.8551 +6454 4 14.1263 29.6193 13.4563 6.10678 -19.1115 21.2229 +6455 4 14.1254 29.8374 14.9735 4.9154 -5.66101 -4.10969 +6456 6 30.4264 19.8612 16.8883 21.8822 -42.1222 -1.02119 +6457 4 30.7186 19.5182 17.7453 7.89699 4.38367 -1.56912 +6458 4 29.8579 20.5689 17.0557 -25.7709 36.069 4.20145 +6459 6 21.3137 21.0352 23.1207 17.1515 -0.95565 24.203 +6460 4 22.2175 21.149 23.495 -16.5785 2.35003 -9.75668 +6461 4 20.7278 21.0809 23.8918 1.9436 3.71589 -4.02445 +6462 6 32.3543 0.425745 25.2542 2.91189 -3.53517 -15.1456 +6463 4 32.2281 0.339162 24.2978 10.7775 -1.18886 4.59452 +6464 4 31.5305 0.792307 25.5362 -21.0885 6.89421 14.2132 +6465 6 26.144 32.4145 27.5224 1.5207 15.2147 0.716215 +6466 4 25.5792 33.1636 27.3089 1.00017 8.92672 2.49827 +6467 4 25.8737 31.7446 26.908 1.40169 -15.6227 -12.5261 +6468 6 31.6924 23.0038 41.4488 2.9891 4.25247 18.5975 +6469 4 32.5817 22.7219 41.7427 -10.6129 2.19465 -7.80737 +6470 4 31.0787 22.7203 0.234806 2.54762 2.31931 -6.22567 +6471 6 54.3675 17.8383 10.7129 6.79577 23.0573 52.4548 +6472 4 53.55 18.2477 10.4428 -14.1319 6.62767 -11.4304 +6473 4 54.6119 17.1874 10.0964 4.54612 -26.2874 -33.1105 +6474 6 15.4111 28.5567 8.624 -23.5209 17.7221 -14.2225 +6475 4 14.7074 29.0083 8.07604 23.4242 -18.2482 9.63627 +6476 4 15.9053 27.9212 8.07642 -10.4486 8.35345 -4.07335 +6477 6 21.923 22.3267 27.6697 4.39763 -15.072 3.90508 +6478 4 22.0757 23.261 27.7591 9.36727 14.8743 -6.39222 +6479 4 22.0153 22.013 28.5729 -4.02641 -8.91923 4.38679 +6480 6 2.936 17.0367 8.13301 26.8737 -0.816539 -9.93732 +6481 4 3.80704 17.1417 7.69888 -17.5309 -13.2134 -6.39661 +6482 4 2.90872 17.8246 8.6543 -8.08771 15.2208 15.3377 +6483 6 27.578 18.2783 3.98106 42.3665 -21.0645 -7.59535 +6484 4 26.9838 18.9866 3.87461 -35.9411 25.5305 -3.32845 +6485 4 28.3853 18.6252 3.56495 -11.0807 -10.9366 8.58166 +6486 6 24.7671 24.5333 8.4671 -3.55267 7.94183 -11.8318 +6487 4 25.0347 23.6359 8.24775 3.17664 -3.45343 1.13667 +6488 4 24.5725 24.5372 9.40731 3.34714 4.39373 0.466573 +6489 6 41.9868 30.4684 13.7801 28.6364 -21.7839 2.09937 +6490 4 42.9472 30.4515 13.6527 -5.43777 20.4489 -0.76134 +6491 4 41.8419 29.5153 13.705 -23.7897 6.87836 6.63004 +6492 6 15.6883 34.6775 41.5701 28.3539 0.757195 5.77675 +6493 4 16.4499 35.2822 41.5481 -1.40988 -1.74654 9.10263 +6494 4 14.9914 35.2483 41.869 -21.9895 7.57474 1.73196 +6495 6 11.1473 19.7636 40.5906 -7.01786 -3.24743 -12.0486 +6496 4 12.0915 19.8265 40.3679 -7.75233 -10.0339 3.8807 +6497 4 10.7912 18.9088 40.243 10.6872 10.1147 9.9033 +6498 6 47.4955 34.5311 14.2936 14.7321 -31.661 -1.66099 +6499 4 46.9342 35.3117 14.2317 -6.87541 2.2103 -19.2779 +6500 4 47.4978 33.9137 13.4978 -3.14061 27.4792 16.9676 +6501 6 12.3981 26.9866 28.4861 26.5251 -74.1409 -7.08463 +6502 4 13.226 26.8461 29.0045 -10.1246 11.0422 -0.548558 +6503 4 12.3843 26.0988 27.9797 -6.45597 45.1087 15.272 +6504 6 27.6352 16.207 39.8297 -11.2321 14.8168 6.13397 +6505 4 27.2166 15.4175 40.1567 -13.0977 -6.13948 14.8525 +6506 4 28.2209 15.8539 39.184 23.7477 -3.37658 -20.6816 +6507 6 33.4012 31.2187 27.2758 -9.34358 5.5086 -22.6345 +6508 4 34.125 31.7676 27.5967 0.31405 7.14405 -9.79506 +6509 4 32.8978 31.7031 26.5666 21.3968 -7.09575 17.214 +6510 6 39.0983 39.5786 31.9234 0.802497 -2.15341 -0.194752 +6511 4 38.8245 39.6381 30.9898 -0.836727 0.773065 10.2743 +6512 4 38.5517 40.2102 32.4207 8.13236 -5.11153 -2.10971 +6513 6 22.8875 16.5662 19.9556 -18.6429 -47.4181 0.677292 +6514 4 23.2714 15.7467 20.3471 4.73069 19.3315 1.98369 +6515 4 22.0725 16.1814 19.5628 10.6014 14.9969 -2.71875 +6516 6 23.9725 21.8734 10.5896 -27.2099 14.1239 -19.8382 +6517 4 22.9807 21.8764 10.5048 23.1264 -0.860286 11.7265 +6518 4 24.1883 21.166 11.1844 -1.51334 -13.3572 20.4185 +6519 6 40.1791 25.4384 2.79385 3.27033 10.4385 -27.7191 +6520 4 40.1215 24.9503 3.60378 -1.57927 -2.0951 21.761 +6521 4 39.8421 26.3422 2.89187 -4.34677 -6.39915 11.9951 +6522 6 15.0222 19.7637 9.4145 -47.1416 28.5942 15.5409 +6523 4 14.7277 20.7258 9.2944 13.9352 -33.0223 -5.4956 +6524 4 14.1981 19.3167 9.80349 37.3596 11.4933 -12.2096 +6525 6 7.16734 24.8761 0.122492 -38.9593 -14.3052 4.78001 +6526 4 7.92262 24.7355 41.4818 28.9246 2.82935 -8.29154 +6527 4 7.37325 25.3267 0.937782 12.1222 2.94845 5.10402 +6528 6 43.395 10.8961 31.3295 35.6095 27.14 14.9602 +6529 4 43.8689 11.0333 30.4778 -14.9331 -12.4968 13.4948 +6530 4 44.125 11.0026 32.0067 -24.5429 -5.74221 -22.764 +6531 6 13.8447 19.0699 27.8622 -3.35019 15.2359 -6.83255 +6532 4 12.9833 18.7163 28.0985 -4.55464 1.4506 5.93475 +6533 4 13.7874 20.0538 27.8435 3.60016 -14.5834 0.921784 +6534 6 3.48728 19.5892 9.61273 -55.7314 7.48447 -10.4955 +6535 4 2.69835 20.0905 9.96963 22.9021 -19.0673 -4.76373 +6536 4 4.2501 19.9102 10.0538 23.4289 5.03115 15.3445 +6537 6 51.0169 19.4212 7.7195 26.3048 39.1054 -53.7154 +6538 4 50.748 20.2575 7.21364 -2.7273 -32.3506 28.7892 +6539 4 51.8579 19.2204 7.21263 -29.2082 -7.0208 18.9647 +6540 6 42.2149 2.6091 10.4112 25.8935 -20.0624 -18.8025 +6541 4 43.1623 2.45904 10.6444 -24.152 11.2038 4.82319 +6542 4 42.1853 2.33112 9.4647 -3.80011 10.6068 21.7004 +6543 6 30.7928 6.43901 35.1986 -21.6247 -20.8821 1.11778 +6544 4 29.8295 6.39304 35.3716 10.0359 5.79706 -2.44011 +6545 4 31.0478 5.50645 35.0814 0.649811 9.90023 -1.69835 +6546 6 52.8722 36.96 18.5947 9.01539 9.27494 -7.55423 +6547 4 52.0657 36.4448 18.5061 -12.9065 3.13675 2.3407 +6548 4 52.6935 37.8522 18.2226 2.03776 -15.609 7.12003 +6549 6 44.2018 6.29599 1.04883 9.29405 17.1768 7.51252 +6550 4 44.5044 7.06671 1.58929 -4.49779 -17.4812 -0.431191 +6551 4 44.952 6.10526 0.487985 -0.115844 -2.61588 -3.46335 +6552 6 42.1326 38.6047 31.1849 18.5327 -13.3283 33.8135 +6553 4 41.7834 38.9864 30.4106 -14.9936 10.8543 -35.8121 +6554 4 41.4904 38.8324 31.8627 -0.641051 1.33351 1.93 +6555 6 43.7219 12.8013 9.05519 -6.282 7.91343 -40.7352 +6556 4 43.3171 13.69 8.87718 10.3632 -22.6116 8.3507 +6557 4 43.9578 12.415 8.15014 1.61383 14.3586 37.3488 +6558 6 13.4062 0.438838 6.51561 -30.6084 29.4042 -0.600484 +6559 4 12.9719 1.14899 7.05573 20.0807 -17.3818 -8.1595 +6560 4 13.3782 0.782754 5.59696 2.59294 -3.03922 8.63079 +6561 6 16.1217 13.2907 10.2805 -3.10591 -25.3511 -12.454 +6562 4 16.8946 12.7568 10.5076 8.02861 4.25978 2.86397 +6563 4 15.5299 12.6092 9.88546 -0.135156 17.9383 7.81515 +6564 6 1.59113 8.48217 4.69745 0.410151 -22.2633 16.3582 +6565 4 1.97054 9.1194 4.11301 8.92831 16.113 -22.7699 +6566 4 2.26765 8.43533 5.38895 -6.97239 3.0759 6.50405 +6567 6 37.2935 1.72102 10.5172 -13.7439 -9.21578 15.0824 +6568 4 37.1042 2.64553 10.595 10.0955 20.4226 -13.0857 +6569 4 36.8105 1.41855 11.2983 8.13599 -13.5394 -0.658926 +6570 6 53.8411 9.88961 17.6933 -45.7386 -38.9159 3.57486 +6571 4 54.5353 10.0399 17.0846 27.4782 6.59889 -23.5339 +6572 4 53.3721 9.08338 17.329 10.482 22.3983 14.0606 +6573 6 45.4787 30.6173 15.8038 -24.3966 -4.27047 13.1326 +6574 4 44.7717 31.1876 16.1963 22.3351 -9.42651 -10.1125 +6575 4 45.1907 29.6979 15.9324 6.84487 10.052 -2.21901 +6576 6 39.9241 16.6394 33.8426 -26.8877 -6.37158 -14.218 +6577 4 39.1549 17.2016 33.5476 23.291 -18.1751 3.42158 +6578 4 39.818 15.753 33.3934 2.94846 26.4583 15.0268 +6579 6 32.8532 24.7638 27.9368 9.55773 21.8346 -14.3088 +6580 4 33.6229 25.0593 28.4772 -14.6217 4.84572 -15.4057 +6581 4 32.6055 25.4822 27.2751 14.9958 -18.2832 35.5187 +6582 6 7.86628 31.6164 24.1091 22.2934 14.9204 62.1634 +6583 4 7.77595 30.8628 24.7489 -5.82572 16.0022 -25.8365 +6584 4 8.17309 32.3545 24.746 -24.9312 -26.1857 -42.8493 +6585 6 43.5324 41.3356 15.8165 16.5067 -5.02973 0.188395 +6586 4 43.1944 0.320073 15.7896 -5.69638 5.43212 -4.38793 +6587 4 44.429 41.3992 15.443 -10.6291 -2.88383 0.315207 +6588 6 20.021 29.5505 33.1902 25.0419 -7.98688 14.3875 +6589 4 20.8911 29.4069 33.5992 2.6372 -12.3274 -8.42754 +6590 4 19.6576 30.1636 33.8147 -14.9588 14.7065 -0.197692 +6591 6 43.4056 21.4569 18.6265 10.2156 -2.1017 15.5441 +6592 4 43.0498 21.3696 19.5313 -0.699705 -7.60676 -10.3888 +6593 4 42.9844 20.831 18.0298 -12.2248 -1.50447 0.773582 +6594 6 3.43117 19.1215 18.408 34.3393 4.70286 11.768 +6595 4 3.22621 20.0564 18.4267 -2.18643 4.81974 -5.59269 +6596 4 2.60088 18.6799 18.3703 -20.3233 -14.3491 -1.28903 +6597 6 41.6742 38.1112 16.3299 0.384784 -42.0766 -46.2559 +6598 4 41.8939 37.3404 15.6708 -9.75075 44.1094 34.3099 +6599 4 42.3403 38.1083 17.0131 5.25517 -2.87066 6.28124 +6600 6 7.56339 36.3915 10.5048 -18.8567 -13.4705 -13.5944 +6601 4 6.70677 36.1596 10.0967 9.18231 15.0261 0.193132 +6602 4 7.92251 35.493 10.5558 6.04756 10.3771 12.1048 +6603 6 36.2642 19.1103 34.8187 -40.4108 -29.7457 -43.4097 +6604 4 35.4719 19.3187 34.2477 20.3247 -4.92751 27.2967 +6605 4 36.4213 19.8813 35.3193 7.80254 33.8099 20.7293 +6606 6 53.576 24.9483 12.6399 1.20561 -0.517111 -17.326 +6607 4 53.6619 25.9414 12.669 8.79141 -29.2645 -7.24265 +6608 4 53.913 24.5623 11.7782 -4.09912 18.2899 28.1509 +6609 6 31.6824 10.4618 21.0892 -21.9557 -25.3726 -8.81809 +6610 4 31.4281 9.67391 21.5915 5.84781 10.5911 6.7189 +6611 4 30.8909 10.5838 20.5303 11.506 8.60894 0.332243 +6612 6 18.1093 28.7861 17.1823 13.2379 18.2354 -13.1758 +6613 4 19.074 28.7105 16.9739 -24.5165 5.38082 5.29014 +6614 4 17.7652 29.607 16.728 11.5472 -26.6353 13.0333 +6615 6 21.6834 18.2239 36.88 17.2587 0.811675 -5.67627 +6616 4 22.5671 18.027 36.4721 -27.7349 -1.55215 19.1593 +6617 4 21.6367 17.7543 37.7464 -1.70499 5.95625 -12.509 +6618 6 25.0551 19.0348 34.2287 -62.1041 -5.07763 23.2016 +6619 4 24.7663 18.3443 34.8719 5.43786 16.9757 -10.9409 +6620 4 25.8827 18.7578 33.9618 64.2031 -27.8273 -22.1538 +6621 6 15.5709 13.019 5.5539 0.00735057 -17.6807 20.5563 +6622 4 15.9927 13.3293 6.36292 0.0692085 12.4919 -5.39058 +6623 4 15.4491 12.0681 5.73828 -2.05735 13.2604 -17.7033 +6624 6 54.47 41.6402 14.7959 12.609 -13.6787 23.2741 +6625 4 54.8097 41.4531 15.6947 -1.45983 11.4249 -10.5768 +6626 4 53.7709 40.9948 14.7271 -15.6812 0.146288 -8.92901 +6627 6 1.6639 26.4809 31.3827 12.672 -25.15 69.1319 +6628 4 2.55491 26.3764 31.7735 -12.447 -0.333387 -5.00094 +6629 4 1.81595 26.6127 30.4938 10.6163 16.8649 -70.5286 +6630 6 32.3417 37.2868 29.6843 -28.8191 13.9029 5.49332 +6631 4 31.5776 37.8992 29.8843 22.0104 -18.6347 -4.04342 +6632 4 33.1171 37.6855 30.0945 4.79121 1.59444 1.77014 +6633 6 52.7104 21.0422 22.8867 -25.9211 15.4876 17.6965 +6634 4 51.8895 21.5407 22.5959 27.9099 -16.7396 2.24416 +6635 4 53.1785 20.6742 22.1421 1.33026 -7.16251 -14.9349 +6636 6 32.7465 28.5808 40.5193 19.5614 -2.95666 4.13778 +6637 4 32.1272 29.2507 40.2236 -19.1805 -2.02865 5.11045 +6638 4 32.5793 28.3106 41.4408 -7.78706 5.87783 -13.0149 +6639 6 23.6078 32.0654 16.3528 6.52471 10.7856 29.7964 +6640 4 24.3701 32.0729 16.9793 -11.8963 -10.2614 -20.8491 +6641 4 22.8856 32.382 16.9256 -1.99185 -7.37994 -15.8659 +6642 6 37.5296 9.17182 29.9714 -32.9897 5.30306 10.5453 +6643 4 36.7716 8.86544 30.5111 15.5785 -5.70066 -5.7121 +6644 4 37.1221 9.9689 29.5744 15.1662 -5.45151 -1.53858 +6645 6 2.26386 24.3835 14.5546 6.71022 -7.72281 -24.2479 +6646 4 1.85963 24.0133 15.3587 -6.19133 3.33276 -9.20692 +6647 4 2.05254 23.8227 13.7642 -0.610841 12.6744 29.5344 +6648 6 27.3686 28.7935 24.7702 8.50672 -13.2399 -34.495 +6649 4 27.2338 28.4442 25.6457 -6.20833 -8.14759 12.6395 +6650 4 27.3624 28.0447 24.1031 3.25167 21.2409 25.246 +6651 6 16.785 2.54959 14.3094 -6.20571 44.0359 18.8502 +6652 4 17.7332 2.53792 14.3228 12.8455 -14.2273 -3.64568 +6653 4 16.4133 1.8101 13.8617 -1.35631 -25.1723 -17.3636 +6654 6 21.8048 39.8028 36.8143 34.4281 41.1875 6.43987 +6655 4 22.7768 39.6281 36.9504 -24.2083 -5.20947 -5.56999 +6656 4 21.4132 39.0119 36.5213 -11.0202 -42.2818 -12.3994 +6657 6 14.0639 6.48367 41.5586 -1.33856 -25.5903 -39.7582 +6658 4 14.9412 6.10051 41.3922 2.86672 3.38346 15.7648 +6659 4 14.0719 7.05039 0.399753 4.3465 12.2327 22.8772 +6660 6 14.5548 16.5075 9.32956 22.0841 -14.7784 -21.2506 +6661 4 15.3586 16.5914 9.87503 -6.36199 2.72911 -6.08794 +6662 4 13.8899 17.0883 9.65711 -8.71884 14.1475 23.1102 +6663 6 8.67066 23.4815 30.5556 -44.0195 -7.59097 13.7496 +6664 4 9.49671 23.6557 30.1334 33.8338 1.75787 0.0184994 +6665 4 8.69311 23.4014 31.5307 16.0679 1.7618 -7.5699 +6666 6 37.6567 2.07706 19.9993 -10.7882 4.4912 14.9507 +6667 4 36.977 2.26584 19.3592 -1.31755 -8.36894 -24.369 +6668 4 37.311 2.65872 20.6865 17.7477 -2.01295 10.0374 +6669 6 42.7201 7.55732 8.02256 37.7013 -31.8103 68.6738 +6670 4 43.2078 7.90139 7.31041 13.9641 18.3531 -33.1003 +6671 4 43.4713 7.36984 8.74143 -54.3005 13.1784 -34.8973 +6672 6 38.5678 29.6657 6.85728 10.4727 -7.97498 12.0381 +6673 4 38.5138 29.2192 7.70857 5.95943 6.40388 2.63109 +6674 4 37.7242 29.471 6.47402 -15.8477 4.38345 -15.5494 +6675 6 42.5297 15.7017 39.7864 -1.2311 2.72873 2.24862 +6676 4 42.7877 16.6334 39.6476 -7.55712 -4.9727 -7.52807 +6677 4 42.0746 15.3358 38.9963 17.4435 12.5166 7.69263 +6678 6 19.8571 7.43592 22.0545 -24.1472 -5.51637 33.4113 +6679 4 19.2244 8.12179 21.7601 9.35088 -5.78158 -2.10146 +6680 4 19.4596 7.11536 22.9248 14.2781 17.6372 -34.9907 +6681 6 27.4149 3.22069 12.5516 40.9266 14.4549 -35.8463 +6682 4 28.3021 3.29229 12.0821 -30.0356 5.19144 18.8294 +6683 4 27.3767 2.28812 12.7581 -5.67627 -4.82192 6.74426 +6684 6 34.4116 6.50186 34.3661 -21.9879 -4.07114 7.78674 +6685 4 33.6675 7.13398 34.4265 8.52018 -4.33452 -1.60522 +6686 4 34.0848 5.70903 34.842 8.55338 12.1797 -0.556276 +6687 6 9.89342 27.9558 39.7643 36.6491 -8.46867 13.0669 +6688 4 10.8456 28.0225 40.104 -41.9626 -4.51635 -15.7261 +6689 4 9.67004 28.8098 39.3873 2.34979 10.3628 -2.65954 +6690 6 50.5619 22.115 6.39208 17.1303 26.4748 31.0688 +6691 4 51.4904 22.4109 6.45725 -8.74694 -11.3909 -7.00891 +6692 4 50.1939 22.6078 7.15954 -8.62199 -11.7106 -16.757 +6693 6 47.1151 11.4881 30.0373 19.0993 -20.4412 31.5796 +6694 4 47.2481 10.8506 30.7795 8.25865 21.4973 -13.9376 +6695 4 46.3269 11.1564 29.6474 -26.9131 -5.13028 -17.9745 +6696 6 25.9416 28.4741 9.79918 -11.6773 -32.55 32.2578 +6697 4 26.8348 28.2861 10.1548 -13.4597 2.20587 -7.83095 +6698 4 25.3328 27.8368 10.2912 20.3964 27.2145 -12.4741 +6699 6 35.4384 36.5941 19.4416 12.9267 19.1414 22.694 +6700 4 35.4164 36.6623 20.432 -0.885856 -8.21646 -20.3497 +6701 4 36.1159 37.2681 19.2232 -9.51806 -6.29836 -4.59986 +6702 6 39.0948 17.8654 12.2958 16.402 12.2899 -6.89152 +6703 4 39.0474 18.8007 12.5965 -2.38328 -10.6878 -1.40665 +6704 4 38.4419 17.3626 12.7715 -16.1853 0.319976 14.0097 +6705 6 2.67108 27.1436 2.40101 -1.75759 -3.65761 -8.1759 +6706 4 1.9876 27.5644 1.84788 8.2175 -2.76418 4.2561 +6707 4 2.53155 27.392 3.3289 1.87867 -1.67129 -3.85288 +6708 6 12.3359 32.2055 21.5153 -21.7508 0.12991 31.168 +6709 4 12.6488 32.0797 22.4173 29.0853 13.2861 -13.6486 +6710 4 11.491 31.8094 21.7155 -17.148 -0.720271 -25.2422 +6711 6 32.8833 32.3716 8.45599 -19.6455 -21.472 -14.5807 +6712 4 33.4538 32.8256 9.05859 9.48117 21.6574 11.6239 +6713 4 31.9723 32.7028 8.50155 9.17651 3.82723 3.41156 +6714 6 12.6485 6.44458 31.9777 -6.29944 1.49663 15.4125 +6715 4 13.1578 6.35833 31.1835 12.9638 -3.65534 -14.9347 +6716 4 11.7474 6.25334 31.7296 -4.07419 -1.29291 -2.47195 +6717 6 41.3645 27.7433 14.0415 -6.01814 -18.8263 -25.007 +6718 4 41.8124 27.3175 13.2596 -11.5333 15.588 22.1217 +6719 4 40.3975 27.5756 13.9407 20.5065 3.01622 5.4742 +6720 6 6.60161 16.499 25.4489 9.93734 -1.87947 -15.8553 +6721 4 7.35848 15.8951 25.4583 3.3895 5.33583 -1.00098 +6722 4 6.02379 16.0419 24.8253 -6.53341 1.34025 8.2366 +6723 6 21.7786 39.2974 13.3607 -58.7317 27.2846 42.4257 +6724 4 22.3848 39.3902 12.6828 41.4687 -6.70168 -50.5194 +6725 4 21.6228 40.2371 13.624 5.27297 -27.3266 2.34771 +6726 6 34.8408 6.01319 6.94562 -18.4641 -1.51643 5.78804 +6727 4 33.8445 5.90926 6.91888 31.3517 2.57767 -4.40922 +6728 4 35.1545 6.28252 6.0657 -8.54142 -2.93715 0.97402 +6729 6 33.0232 30.4151 33.1713 -30.7469 -3.39927 -39.9685 +6730 4 32.1382 30.6983 32.7963 25.7009 -18.3352 9.36685 +6731 4 33.1108 30.988 33.8978 7.7837 23.494 30.6115 +6732 6 15.4491 32.4129 12.2013 37.3068 -21.1945 16.3611 +6733 4 16.3823 32.073 12.2446 -28.3662 8.39135 1.47263 +6734 4 15.4224 32.8258 11.3561 0.313824 15.5191 -23.5701 +6735 6 12.6648 26.6033 21.3782 33.3074 -46.6123 -64.9668 +6736 4 12.0344 25.8976 21.5501 -12.6652 14.4466 17.403 +6737 4 12.7392 27.3327 21.935 -15.9008 39.2731 46.5109 +6738 6 47.0171 36.3051 29.9756 -14.9097 -3.99946 59.7783 +6739 4 47.3887 37.0247 30.5306 -0.120183 -5.44251 -19.0377 +6740 4 46.4147 35.8463 30.6463 22.302 11.6315 -30.1098 +6741 6 0.299553 12.7005 23.3858 -50.0817 10.3486 20.6993 +6742 4 0.55843 11.8154 23.133 6.9712 -0.709946 -9.28769 +6743 4 54.2783 12.6185 23.429 39.7411 7.62342 -2.706 +6744 6 54.1651 18.9185 21.5773 -27.3575 7.2555 -32.8787 +6745 4 0.055729 18.801 21.8215 42.2187 -10.4087 33.76 +6746 4 54.2632 18.7361 20.6344 -21.3012 2.13243 0.141772 +6747 6 25.7162 24.2884 23.7449 23.2111 -33.139 -2.25213 +6748 4 25.1836 23.5617 23.2944 18.61 24.747 21.927 +6749 4 26.5708 23.8587 24.0884 -36.4232 14.4676 -16.0896 +6750 6 11.8952 29.0236 26.8796 9.31073 -5.31833 9.58593 +6751 4 12.582 29.6684 27.1204 -3.01706 -1.21814 -5.31042 +6752 4 12.0145 28.319 27.5465 -5.16863 11.8863 -12.5997 +6753 6 48.0052 35.8598 10.6996 -18.0426 -22.591 -32.4945 +6754 4 48.7896 35.6794 10.1443 -7.64403 10.0758 9.7343 +6755 4 48.2747 36.3464 11.4544 19.4818 11.8303 20.3364 +6756 6 47.6544 29.8545 36.9555 47.7155 -39.8456 -42.9298 +6757 4 48.1196 29.373 36.1789 -16.9409 17.9192 43.9777 +6758 4 46.9556 30.2951 36.4995 -17.6283 12.0501 3.0439 +6759 6 7.32865 12.3513 10.6225 -20.3459 13.1064 -14.334 +6760 4 7.20572 12.8267 9.76478 7.03806 -14.4953 16.449 +6761 4 6.49136 12.5857 11.0944 24.1086 -12.0498 -8.15528 +6762 6 52.9256 15.9641 4.89737 -18.3283 -2.7411 -11.4996 +6763 4 53.001 16.1105 3.94443 2.36662 -0.713792 8.85774 +6764 4 53.8018 16.0105 5.25645 21.1817 2.44507 8.14275 +6765 6 10.6731 16.9472 34.6118 -36.7423 -4.99845 -47.4494 +6766 4 11.0533 16.8484 35.4724 -5.12202 -12.2675 26.0308 +6767 4 9.83371 16.4151 34.3796 40.245 18.7583 25.5995 +6768 6 25.147 31.0596 36.0152 -5.60145 -19.7687 -32.0201 +6769 4 25.7935 31.7656 36.1171 1.22463 2.78419 -3.72446 +6770 4 25.3418 30.5949 35.1615 -4.38154 15.6016 24.1358 +6771 6 34.0913 21.8858 41.4775 -4.76405 18.1665 32.5634 +6772 4 33.6625 21.1007 41.1787 -2.29922 -28.5955 -6.85504 +6773 4 34.6054 22.1733 40.7506 14.2114 10.2598 -30.2937 +6774 6 15.7731 30.0818 1.26798 39.0641 -13.3599 -49.0464 +6775 4 15.0823 30.4241 1.791 -23.818 19.5269 30.6537 +6776 4 16.2108 30.862 0.84325 -15.3415 -19.24 18.755 +6777 6 29.5302 27.8609 16.6022 -41.3972 -29.0796 28.0786 +6778 4 29.3307 26.8764 16.753 17.6765 42.2449 -1.67193 +6779 4 28.8227 28.3009 17.156 20.6394 -5.21731 -15.3441 +6780 6 39.6438 9.77612 0.552706 9.07327 13.2864 29.0584 +6781 4 40.129 10.5839 0.897097 -15.1313 -20.9808 -12.8857 +6782 4 39.4906 9.23066 1.36029 2.34479 9.54176 -15.0004 +6783 6 1.51524 31.8825 16.4089 -15.0842 0.567558 32.708 +6784 4 2.11225 32.2249 15.7721 17.5465 17.6302 -23.3114 +6785 4 1.56386 30.9485 16.2687 -0.663138 -25.5376 -6.36093 +6786 6 8.73078 39.8635 25.0545 2.96185 -34.7465 -17.9129 +6787 4 8.00321 39.5602 25.6169 4.07363 9.59654 5.53067 +6788 4 8.89391 40.7829 25.2096 -1.06312 24.7623 5.36493 +6789 6 42.3301 10.2778 9.76455 0.0249942 22.0437 -8.66619 +6790 4 42.035 10.1947 10.6715 6.68889 -4.55788 7.04955 +6791 4 42.6957 11.1854 9.68656 -1.85544 -15.7885 0.75259 +6792 6 13.241 7.61416 1.95847 -11.6175 -6.73398 30.6404 +6793 4 13.9892 7.82191 2.54806 -1.36929 5.6022 -7.80568 +6794 4 12.5695 7.22502 2.56499 11.7798 7.16895 -16.7116 +6795 6 18.7434 40.0583 14.2212 10.8937 -7.32712 21.4541 +6796 4 19.2417 39.7541 15.0131 -1.99408 15.6159 -18.1773 +6797 4 17.935 39.549 14.2832 -4.44855 -3.57314 -3.37042 +6798 6 20.0977 14.0454 38.5561 35.4799 -67.417 -7.49733 +6799 4 20.2641 13.632 37.67 -9.31749 10.6865 24.2255 +6800 4 19.7827 14.877 38.3297 -23.7972 64.5272 -8.60678 +6801 6 22.6565 28.8842 34.0588 -5.52315 8.37947 20.7951 +6802 4 23.0585 28.228 33.4828 2.77778 -4.34029 0.307399 +6803 4 22.9395 28.703 34.9822 0.354749 -6.57221 -14.6515 +6804 6 22.6874 4.70198 5.2328 -25.042 -9.90055 15.5414 +6805 4 22.1274 3.9708 5.56882 12.1557 -0.0327816 -16.8284 +6806 4 22.5434 5.31639 5.94822 12.9551 16.3877 4.62095 +6807 6 23.6492 33.9942 38.3998 23.375 33.8394 -43.1733 +6808 4 22.8011 33.6715 38.57 -44.227 -25.7371 21.164 +6809 4 23.4749 34.4069 37.5183 19.103 -7.547 16.6445 +6810 6 48.374 21.3549 17.2744 -0.727013 41.2048 -23.9838 +6811 4 48.2041 22.3166 17.0448 3.0192 -25.1475 26.0409 +6812 4 48.3509 20.9743 16.3868 -2.31832 -8.94154 10.8829 +6813 6 11.5758 10.9938 8.63273 -18.0621 42.8191 15.9647 +6814 4 11.6313 10.2483 9.25156 -2.19238 1.01339 1.87179 +6815 4 11.0547 11.7764 9.03291 21.9333 -36.8133 -6.7089 +6816 6 40.0924 28.1686 33.4857 17.1635 -5.37387 30.2378 +6817 4 41.046 28.3881 33.5354 -13.2006 -3.32107 -11.2861 +6818 4 39.7443 28.4933 32.6629 4.51627 6.28126 -11.3213 +6819 6 47.3837 25.6703 5.29617 28.7657 21.9065 -4.48206 +6820 4 46.461 25.5322 5.12569 -20.8862 2.51482 -4.893 +6821 4 47.6179 26.6114 5.08959 -12.3293 -15.1007 -0.275896 +6822 6 21.6517 35.2222 23.996 27.7917 10.3485 -3.89698 +6823 4 21.6311 34.5383 24.6593 -10.5502 -12.8786 6.64496 +6824 4 22.5954 35.4881 23.9966 -15.7417 2.23004 -2.6139 +6825 6 8.24409 41.4919 8.41354 9.22969 12.4334 -12.8549 +6826 4 8.15 40.8674 7.67873 -1.07657 -2.81584 5.48771 +6827 4 7.83543 41.113 9.18983 -1.52095 -3.2343 5.88405 +6828 6 16.4798 31.1082 22.2131 -4.24513 -17.8742 -2.35359 +6829 4 17.0752 30.8161 21.5077 -7.18137 4.28218 -7.0656 +6830 4 17.0564 31.1902 22.9696 5.97679 -0.907857 10.4567 +6831 6 54.7122 0.459271 28.3177 -16.7834 -37.5181 -6.57119 +6832 4 0.641958 0.15455 28.3975 4.09167 16.1916 -1.73275 +6833 4 54.5379 1.34634 28.6236 20.797 14.6923 4.72985 +6834 6 48.4477 15.3762 4.17752 -7.35125 -30.0531 -4.44848 +6835 4 49.1738 15.1128 4.81019 -14.8803 0.337287 -24.8229 +6836 4 48.0902 14.5922 3.6288 23.2827 31.0113 24.8784 +6837 6 34.3541 7.00171 40.4295 26.6588 -46.9533 -23.8625 +6838 4 33.6168 6.99428 39.8319 -14.4938 10.2897 -3.98371 +6839 4 34.9839 6.35967 39.9588 -19.3291 28.4488 24.7248 +6840 6 41.3507 3.37676 17.0028 -19.6969 -26.4955 -6.96819 +6841 4 41.02 2.66518 17.5936 5.53648 12.9859 -1.78552 +6842 4 41.944 3.90566 17.5305 10.5068 9.85924 8.73726 +6843 6 48.4427 20.685 14.5419 46.8112 -36.6841 26.4704 +6844 4 48.0177 21.3487 14.0717 -32.7597 47.8552 -32.6818 +6845 4 49.3877 20.9188 14.5227 -9.08294 -4.43462 -1.64124 +6846 6 52.4922 28.1277 37.1182 6.87418 8.84651 -10.3419 +6847 4 53.4134 28.4024 37.0408 3.12987 -6.6922 4.15316 +6848 4 52.2752 27.8963 36.2007 -7.47166 7.06161 9.73328 +6849 6 53.8774 18.5638 18.79 -18.2161 -77.5341 7.0005 +6850 4 54.7018 18.1425 18.5274 3.76082 -0.315502 -3.76089 +6851 4 54.0435 19.4528 18.7445 16.4561 77.5259 -2.54699 +6852 6 41.0011 39.1407 28.7879 -31.3786 -4.09579 71.7092 +6853 4 41.3911 39.2094 27.9661 28.9736 8.71878 -68.6315 +6854 4 40.0521 39.3021 28.7019 -2.27612 -3.41331 -6.23213 +6855 6 38.2743 8.75074 24.2285 24.5029 -7.68366 -19.8132 +6856 4 39.1919 8.60362 23.8621 -28.3827 4.68959 18.7737 +6857 4 38.3545 9.42009 24.9092 0.456349 2.35846 11.2764 +6858 6 2.99111 29.1615 9.6319 43.2691 -54.6401 14.341 +6859 4 2.5338 28.6319 8.99687 -12.0219 1.86489 -18.3516 +6860 4 2.58318 29.9865 9.638 -27.8835 49.5023 8.75508 +6861 6 27.5756 29.2755 18.3378 -4.01048 -11.7045 41.1881 +6862 4 26.7643 29.1652 17.8389 -11.7278 -2.11582 -9.62984 +6863 4 27.2839 29.0037 19.2864 20.9622 13.2114 -52.0932 +6864 6 11.8501 21.1733 10.1172 4.58733 -51.566 26.4002 +6865 4 12.2099 22.0246 9.9906 13.4732 33.828 -10.0235 +6866 4 12.4495 20.7458 10.776 -15.5727 16.0367 -15.8372 +6867 6 16.9004 32.2989 0.299881 0.133752 -22.2186 -6.7835 +6868 4 17.7029 32.7095 0.626455 9.4749 11.3588 3.4417 +6869 4 16.2118 32.9605 0.285394 -3.66285 20.1796 -4.1714 +6870 6 1.30064 17.4766 22.5523 32.9941 -5.4384 -19.965 +6871 4 1.2446 16.5356 22.2294 -6.1018 21.6977 3.5382 +6872 4 2.22906 17.8023 22.3815 -23.7878 -13.737 8.2324 +6873 6 41.5474 6.85538 29.3077 15.2611 30.5857 3.861 +6874 4 41.7413 5.96016 29.5642 -1.91107 -14.5726 0.121693 +6875 4 42.0251 7.37916 29.9826 -12.8279 -1.76094 -5.06557 +6876 6 10.5087 10.782 13.8577 27.0965 -13.6956 13.3978 +6877 4 10.7007 11.2274 13.0253 -2.16043 3.73872 -7.98734 +6878 4 11.2742 10.169 14.0479 -24.5023 11.0776 -3.5626 +6879 6 39.8289 15.4978 40.8346 25.2099 1.13818 0.661387 +6880 4 40.0487 16.0673 40.0758 -9.90377 -2.84048 2.34508 +6881 4 40.6829 15.4254 41.3222 -18.4618 6.82556 -4.74882 +6882 6 26.5164 19.6052 40.5088 -9.33805 1.61856 -11.7217 +6883 4 27.41 19.9717 40.4897 0.274496 -7.70925 5.49567 +6884 4 26.4209 18.9712 41.2422 6.64723 7.57269 5.06511 +6885 6 54.036 8.18782 13.7715 27.5212 34.9045 -2.54262 +6886 4 54.5316 7.46918 14.1378 9.61628 -19.3806 0.327355 +6887 4 53.1925 7.88218 13.5309 -39.9219 -15.1658 -7.5943 +6888 6 15.6949 25.3434 10.6718 -31.7842 -7.37099 0.0612328 +6889 4 15.1805 25.3333 9.84403 14.6699 1.30202 -4.92807 +6890 4 14.9666 25.3615 11.3188 15.8696 -4.15214 -3.47235 +6891 6 18.5987 3.44175 21.9294 71.7321 -9.69418 15.9409 +6892 4 19.6071 3.44542 22.1959 -64.1569 1.8736 -14.3483 +6893 4 18.6296 3.58776 20.9721 -7.77871 5.49431 4.81248 +6894 6 50.8883 20.6265 18.5187 28.1172 41.6529 17.9746 +6895 4 50.1573 21.1733 18.1958 -9.23125 -9.06144 -4.34911 +6896 4 51.4834 21.2842 19.0045 -23.468 -29.5191 -15.1667 +6897 6 53.3673 20.9038 31.2869 -12.1652 -1.18869 -3.23134 +6898 4 53.2409 20.9073 32.2442 5.88471 -1.70994 -0.407299 +6899 4 52.4717 20.8062 30.9053 11.2743 1.61965 3.90294 +6900 6 52.8102 27.6189 28.9831 -34.4743 -7.30027 30.0453 +6901 4 52.2848 27.4362 29.7987 1.4862 0.901255 -27.4551 +6902 4 53.4947 28.1361 29.3473 35.4934 25.3811 1.80223 +6903 6 33.3112 15.6955 11.3264 12.7704 9.00306 37.7013 +6904 4 33.4999 16.1238 12.2198 -3.00415 -23.4283 -28.8796 +6905 4 32.4346 16.0003 11.1059 -7.33456 8.94646 -4.12361 +6906 6 20.3875 26.8057 27.4813 21.213 -4.31231 15.2493 +6907 4 19.6396 27.3594 27.2578 -2.8557 9.66202 -0.370116 +6908 4 20.9667 27.2946 28.1279 -24.4059 -13.8952 -19.2793 +6909 6 8.54399 2.06163 14.1713 4.36483 17.1543 -0.299448 +6910 4 8.13837 1.20516 14.196 -9.47708 -17.773 2.17407 +6911 4 8.01805 2.60085 14.7902 6.78451 -6.83093 -3.12033 +6912 6 40.1002 7.56575 40.6778 12.4019 9.60944 38.6013 +6913 4 39.712 8.14959 41.3779 4.03526 -4.70584 -30.6789 +6914 4 40.8329 7.16354 41.1893 -8.78874 -6.51591 -16.4763 +6915 6 6.89044 6.83556 10.7869 16.1514 15.8461 -3.23426 +6916 4 7.31622 7.70217 10.5979 -16.164 -15.6489 3.8938 +6917 4 7.04178 6.69918 11.735 -3.2221 -0.411834 -4.21297 +6918 6 31.2643 6.58983 20.136 22.5576 -57.6677 6.94967 +6919 4 30.6637 5.92034 20.5005 -2.47046 2.78164 8.35653 +6920 4 30.7152 7.30056 19.9711 -35.0351 52.1138 -11.6241 +6921 6 54.5411 21.0454 27.2925 4.1013 -43.0328 84.8338 +6922 4 0.071192 20.2129 27.5399 -15.6737 30.1382 -21.2093 +6923 4 54.6532 21.3072 26.4181 12.1035 8.54749 -60.3726 +6924 6 4.75213 23.1508 16.2245 -49.4139 4.34438 -28.0546 +6925 4 4.2471 24.0009 16.1592 20.3634 -17.2761 5.59937 +6926 4 5.4972 23.3136 16.7675 27.2932 5.42097 22.4316 +6927 6 25.5515 11.0241 14.8358 9.2665 0.546345 5.2197 +6928 4 26.0976 10.3608 15.3182 -9.73323 12.0118 -14.516 +6929 4 25.8683 11.8947 15.1133 0.0398252 -5.90721 -2.6003 +6930 6 41.1974 41.7784 29.942 -27.7855 -7.97533 -10.6302 +6931 4 40.9203 40.8727 29.6366 8.3922 29.767 6.72032 +6932 4 40.4023 0.465719 29.8931 18.9924 -15.525 2.17149 +6933 6 52.2793 15.2936 41.6313 19.4314 -9.06844 -20.2837 +6934 4 51.991 15.9601 0.331443 -10.9307 10.9541 10.4228 +6935 4 51.6032 14.6231 41.5544 -13.8311 -6.7739 0.824233 +6936 6 37.7418 21.7882 37.8505 9.73059 24.2058 3.49681 +6937 4 37.8176 20.8655 37.6583 6.26781 -24.8638 0.142384 +6938 4 38.1128 21.8753 38.7352 0.661952 0.248137 2.40564 +6939 6 23.8436 9.73697 27.5598 -17.3101 -56.824 -21.1542 +6940 4 23.6823 8.97924 26.8635 13.0753 42.6322 38.797 +6941 4 23.3674 9.48178 28.3892 6.27388 8.11738 -19.7561 +6942 6 43.0121 28.0431 32.8137 29.5034 -18.022 1.83467 +6943 4 42.9555 27.148 33.1715 -16.7807 6.42622 4.12236 +6944 4 43.9561 28.0675 32.5908 -15.6612 14.0802 -2.62256 +6945 6 34.1451 21.2362 11.9042 -10.4207 -39.0944 -3.26361 +6946 4 33.7785 20.3444 12.1585 8.75301 27.3815 0.918114 +6947 4 33.7383 21.3833 11.0382 -2.92284 10.3561 2.31655 +6948 6 10.5016 31.8267 10.0873 5.91889 6.7472 5.74276 +6949 4 10.9186 32.6594 10.3946 -11.2895 -14.4825 -9.55855 +6950 4 9.99233 32.0033 9.274 9.03923 7.50024 8.93884 +6951 6 35.8744 37.1309 22.1208 9.07655 -0.20125 -37.6945 +6952 4 36.7757 37.5102 21.9868 -16.2539 -8.14962 7.83623 +6953 4 35.5893 37.243 23.0078 -0.963312 7.56509 34.0991 +6954 6 27.293 4.59192 27.4599 -62.9251 -2.97268 8.43797 +6955 4 27.8573 4.63875 28.2367 1.75868 -0.322614 6.7695 +6956 4 26.3027 4.46726 27.7774 60.9698 2.85981 -12.9146 +6957 6 39.0165 22.2861 10.6525 -25.2911 9.99335 20.5692 +6958 4 39.5938 21.9801 9.97437 16.8498 -5.94336 -19.6369 +6959 4 38.1468 22.3658 10.2352 2.38909 -7.32087 0.337973 +6960 6 30.765 39.1813 10.9358 -26.8864 17.0789 0.421318 +6961 4 31.7273 39.1993 11.0368 0.254075 -10.0442 -6.8497 +6962 4 30.3957 38.288 10.8473 24.5485 -0.522695 0.476538 +6963 6 44.5972 26.9475 2.20695 17.6159 -27.9211 -0.145864 +6964 4 44.8477 26.0903 2.61727 -13.9349 20.2639 -7.87324 +6965 4 45.3006 27.0404 1.55025 0.322606 15.9 1.66232 +6966 6 23.7817 14.549 26.4845 -13.1218 37.1912 -28.6876 +6967 4 23.5085 15.1786 25.7375 18.3344 -26.327 26.4977 +6968 4 23.2314 13.7794 26.3439 -3.10125 -8.02717 6.138 +6969 6 38.3349 13.3785 39.6531 51.0719 11.8768 18.627 +6970 4 39.1134 13.8424 40.1004 -28.3003 -20.0613 -21.9332 +6971 4 37.637 14.0102 39.7945 -20.9869 -1.09015 1.55638 +6972 6 17.9076 17.2343 29.3998 2.5182 -11.8623 9.07057 +6973 4 17.7005 16.8028 28.5679 -0.208052 -3.06359 -6.42367 +6974 4 17.2973 17.9612 29.4206 -13.3644 14.2602 6.84169 +6975 6 17.427 29.8312 9.9167 5.70667 9.14636 11.5297 +6976 4 16.5259 29.8398 9.63655 -18.5043 -5.93208 -2.5299 +6977 4 17.9097 29.6705 9.11934 16.3543 -3.78316 -10.6623 +6978 6 35.6302 6.05705 19.6249 -12.632 -1.17761 -30.1407 +6979 4 35.1756 5.57436 18.904 4.12491 -0.359791 14.6292 +6980 4 35.7342 6.9119 19.1826 9.40393 1.91765 12.7562 +6981 6 18.674 22.2857 17.523 8.42296 3.39096 21.1197 +6982 4 17.7402 22.4481 17.6821 -9.17854 0.615652 -6.61815 +6983 4 18.8674 22.3747 16.5992 -7.41694 3.44878 -20.9034 +6984 6 20.0258 3.81405 32.2871 -5.45876 10.2161 0.982716 +6985 4 19.684 4.03807 31.424 -2.67861 3.00481 -7.64614 +6986 4 20.9375 3.54321 32.099 -1.59169 -5.33194 9.42598 +6987 6 5.47094 6.98417 8.10987 -1.95658 -27.204 5.03178 +6988 4 5.85072 7.84658 8.088 3.96324 28.039 -6.11929 +6989 4 5.94584 6.55919 8.82772 -3.50663 -6.33739 10.9422 +6990 6 44.182 20.5312 25.5979 43.1361 -13.705 -19.148 +6991 4 44.6875 21.1042 26.1493 -15.9255 27.6084 29.7698 +6992 4 44.9726 20.2272 25.1253 -26.0739 -14.4287 -20.9555 +6993 6 43.9621 36.9892 17.8709 27.7049 17.1418 -9.42399 +6994 4 44.6647 37.4643 17.3692 -13.724 -4.61297 12.4448 +6995 4 43.6121 36.3808 17.225 -14.1002 -14.0328 0.985329 +6996 6 34.6183 10.1148 16.2555 -4.96303 14.2933 -37.1542 +6997 4 34.4099 10.1014 15.264 7.63186 -7.52385 38.4141 +6998 4 34.6455 11.0716 16.4378 1.03434 -4.81203 3.48645 +6999 6 23.6535 3.43617 1.32551 9.32991 -27.0385 -60.023 +7000 4 23.5361 2.47498 1.09872 1.70789 26.2755 24.74 +7001 4 23.8607 3.79652 0.414552 -11.3127 6.44054 37.9529 +7002 6 33.4225 38.9606 5.09116 -45.0556 15.9463 14.7537 +7003 4 32.9187 38.171 4.91655 10.2233 -24.4058 -4.43744 +7004 4 32.6531 39.5198 5.39063 34.9247 3.3662 -8.43025 +7005 6 22.5542 32.508 35.8091 -1.62577 21.6885 -22.4452 +7006 4 23.4313 32.1432 35.8321 13.5304 -8.64793 9.08541 +7007 4 22.6972 33.4304 35.4917 -7.91418 -12.6316 15.6694 +7008 6 32.4209 37.2696 13.8263 22.6153 37.4816 -15.7005 +7009 4 31.6314 36.8608 13.5507 -35.0264 -17.3769 -13.0658 +7010 4 32.7321 36.7183 14.5153 12.3601 -27.6025 17.2047 +7011 6 52.6048 12.7515 39.5965 -13.8302 -6.28036 -1.32475 +7012 4 53.26 13.3571 39.2655 9.70847 9.80763 -6.22213 +7013 4 53.0114 12.2827 40.3245 7.10516 -3.61819 3.538 +7014 6 28.8284 14.5654 1.23244 38.3097 18.383 -14.9432 +7015 4 28.2834 13.8143 1.34735 -23.3809 -22.0338 3.15251 +7016 4 28.3672 15.33 1.56727 -9.74512 0.414323 3.22557 +7017 6 1.45359 32.4205 23.3989 -1.05001 -40.1011 -18.1189 +7018 4 1.47013 31.5606 22.9188 -1.41837 10.7967 19.8874 +7019 4 1.97354 32.9442 22.8182 11.5552 29.203 -12.5869 +7020 6 54.3296 23.3325 28.9716 1.50467 4.34178 0.834044 +7021 4 54.2574 22.8567 29.7964 -0.193368 0.82753 11.1745 +7022 4 54.4723 22.6371 28.331 0.325397 -5.40149 -8.07104 +7023 6 14.3127 12.1509 35.6633 -33.5663 -10.8168 -13.6472 +7024 4 14.2878 12.7047 36.4184 6.74358 21.3133 20.6565 +7025 4 15.1756 11.8015 35.6107 35.8459 -8.25269 -4.05635 +7026 6 18.9986 6.53226 41.2771 -21.1361 -24.8418 -24.3627 +7027 4 18.366 5.78703 41.1105 9.63211 18.6573 18.8829 +7028 4 19.3119 6.48514 0.272589 3.11598 2.01554 11.5533 +7029 6 5.32991 17.8836 20.3428 -30.4167 16.0599 6.69424 +7030 4 4.7967 18.411 19.709 2.93149 -9.05217 4.33299 +7031 4 4.77097 17.8526 21.1546 15.0176 4.61027 -13.5236 +7032 6 24.7236 34.9657 30.1688 -3.59195 -26.0802 -14.261 +7033 4 24.7803 35.9013 30.0428 5.00342 21.1487 3.94382 +7034 4 24.6904 34.5809 29.2706 1.13339 13.2018 12.9935 +7035 6 31.868 4.6188 18.1813 26.0749 -11.7783 -2.21043 +7036 4 31.7807 5.26575 18.8694 -2.85928 14.415 8.06415 +7037 4 31.0011 4.54965 17.8036 -17.7428 -0.954819 -5.29079 +7038 6 8.70915 17.4782 5.92977 -5.10088 36.478 0.166614 +7039 4 7.99285 18.1665 5.8727 10.0003 -20.7449 -0.10219 +7040 4 9.53277 18.014 5.87919 -8.17468 -12.6369 7.06335 +7041 6 29.8448 10.9674 14.467 -9.24737 10.8237 6.24964 +7042 4 29.3518 11.4625 13.8111 -3.5417 -3.22768 -11.9456 +7043 4 29.8741 11.602 15.1948 7.6561 -6.41884 12.5924 +7044 6 48.7193 10.2987 32.5837 48.7914 -16.5053 -5.27468 +7045 4 48.664 9.84191 33.449 -1.5926 15.0761 -9.20872 +7046 4 49.6917 10.1556 32.2801 -49.2626 10.4163 8.33251 +7047 6 8.33128 15.6672 37.865 4.36755 4.12409 -33.9682 +7048 4 8.08142 16.0688 38.661 -6.22033 14.9054 48.1983 +7049 4 7.78443 16.1766 37.2488 7.82296 -4.92397 -7.06368 +7050 6 50.3849 3.07587 17.3306 53.0616 0.797084 -5.54454 +7051 4 49.9901 2.96071 16.4818 -23.7547 4.5323 -14.3202 +7052 4 49.831 3.21284 18.0832 -29.2444 4.71684 15.357 +7053 6 14.687 38.3962 10.9034 11.8452 2.26847 -28.7684 +7054 4 14.4993 38.5723 11.8231 -13.1425 0.700252 11.382 +7055 4 14.2628 37.5785 10.602 -2.45756 1.24341 13.1034 +7056 6 34.1174 6.37976 10.8168 12.9161 5.50138 13.5595 +7057 4 34.1292 7.23477 10.3416 2.23773 -14.4836 1.59416 +7058 4 34.9287 6.34152 11.3848 -14.7297 9.70771 -12.8953 +7059 6 7.1619 37.5492 17.6341 50.2032 -5.81562 0.15107 +7060 4 8.17599 37.5098 17.465 -47.7372 -0.307972 7.49553 +7061 4 7.05745 37.0565 18.4805 -8.53445 9.44148 -12.9936 +7062 6 51.515 11.3168 16.7982 -26.0757 5.86397 -27.0874 +7063 4 52.235 10.8459 17.1551 30.0977 -19.3818 20.7126 +7064 4 51.5008 11.0547 15.8562 -2.22905 10.0255 8.80825 +7065 6 15.6633 8.64974 3.19872 2.04011 -21.0584 -36.8111 +7066 4 15.359 9.2987 3.81038 -7.3063 19.0886 25.5551 +7067 4 16.1924 8.00887 3.67257 5.32849 -2.14206 7.59436 +7068 6 5.43671 21.4488 11.9213 -35.1135 30.2715 2.68526 +7069 4 5.1197 22.3031 11.5306 26.1226 -15.3225 -1.30607 +7070 4 4.71321 21.2794 12.5494 12.8867 -7.97314 3.40019 +7071 6 50.1888 24.041 37.9733 -16.5158 11.6838 -8.72192 +7072 4 49.5513 24.2503 37.2525 13.6843 -9.6942 16.9361 +7073 4 50.7608 23.3204 37.7156 0.52347 -2.66969 -5.08066 +7074 6 39.7366 11.2383 31.6978 23.7892 31.0409 -10.9794 +7075 4 40.3477 11.919 31.322 -8.85632 -23.7146 9.45819 +7076 4 38.8907 11.643 31.516 -11.7678 -2.00245 1.00495 +7077 6 26.6862 10.831 20.5846 -4.64528 13.8134 22.6501 +7078 4 26.37 11.3609 21.3584 5.46785 -6.26709 -23.7021 +7079 4 26.5097 9.94471 20.9062 3.28762 -9.42115 -6.7075 +7080 6 12.5617 17.5693 18.1619 57.3415 -16.6047 -35.4946 +7081 4 12.3732 16.6356 17.927 -10.1847 12.7431 11.2408 +7082 4 11.9536 17.9401 18.7496 -47.3477 6.23269 31.2745 +7083 6 47.7779 31.603 17.3345 -16.0229 -2.6295 -18.0517 +7084 4 48.4774 31.3981 17.9449 0.342859 -12.7175 10.4199 +7085 4 47.3751 30.7658 17.0144 6.51745 15.1025 2.87388 +7086 6 1.06661 3.38166 18.5387 0.482315 1.39351 -20.5486 +7087 4 1.47214 3.81044 19.3024 -7.19452 2.23946 8.83247 +7088 4 0.121217 3.21323 18.6865 2.92702 6.89788 10.7589 +7089 6 26.5916 20.3882 15.3141 4.05487 -19.1164 -7.10575 +7090 4 27.0276 19.5492 15.0037 -7.93965 16.9744 10.3813 +7091 4 25.6772 20.1067 15.4922 9.40368 -0.641397 -3.80974 +7092 6 42.0092 3.03717 36.7607 9.58516 7.42569 -27.539 +7093 4 41.472 2.27114 36.5289 -4.68032 -10.5632 12.6255 +7094 4 41.9749 3.27199 37.6769 -10.2045 -8.66607 25.0137 +7095 6 39.3197 22.4482 33.2161 17.1359 -6.1719 -1.11969 +7096 4 39.6777 22.5385 34.1471 -14.6651 4.73191 -34.7467 +7097 4 39.2891 23.3308 32.7977 1.66572 -7.01471 12.3298 +7098 6 18.4983 34.959 11.9233 -52.4092 11.8234 -6.15541 +7099 4 19.3311 34.9297 12.2931 62.358 -5.27325 28.8625 +7100 4 17.9525 35.2018 12.6795 -15.7268 -2.39727 1.11957 +7101 6 22.849 14.1156 0.206953 9.43339 -22.8796 20.8561 +7102 4 23.1273 14.7687 41.4941 9.338 18.1693 -9.76493 +7103 4 23.4344 14.2183 0.991573 -8.36464 7.13735 -11.7533 +7104 6 31.0127 16.6435 33.7717 -75.3989 -12.3916 10.6429 +7105 4 30.4261 16.8588 33.0132 20.7291 0.745933 12.1228 +7106 4 31.8948 16.7604 33.5238 39.9201 13.7608 -15.1754 +7107 6 28.4056 35.5121 5.54765 -4.91817 12.0412 -0.933493 +7108 4 29.0647 34.8486 5.74161 15.0982 -5.96625 -1.02933 +7109 4 28.8561 36.3656 5.44297 -1.6946 -6.58589 1.12865 +7110 6 2.06022 31.4415 10.6404 20.6415 1.38777 10.2498 +7111 4 2.4899 32.1989 10.2195 -2.44284 -2.19106 -3.22737 +7112 4 1.13111 31.6267 10.6164 -17.6565 -0.143118 -7.1498 +7113 6 5.95467 9.75858 21.3545 2.17354 8.87983 -50.8842 +7114 4 6.2643 10.5435 20.7894 -11.3634 -34.5597 22.4005 +7115 4 5.48441 9.14719 20.7121 9.8282 23.6666 23.1144 +7116 6 24.7866 26.6177 2.6661 -24.4024 -28.5469 2.9707 +7117 4 23.9476 26.6963 2.18158 9.10826 11.4817 -7.6186 +7118 4 24.6214 25.7954 3.1805 15.5163 19.2379 2.11057 +7119 6 45.7515 4.24664 18.6084 -0.948574 6.19926 2.59566 +7120 4 46.4738 4.91595 18.5123 -9.05862 -19.7882 -0.326833 +7121 4 46.0843 3.34349 18.421 4.31178 15.089 3.21664 +7122 6 4.45878 0.783326 15.9106 20.8465 2.39674 -2.22601 +7123 4 4.33336 41.7534 15.8294 -11.1347 -14.3847 -2.31303 +7124 4 5.37758 0.813141 16.2285 -10.0444 13.1447 -0.149196 +7125 6 2.44065 19.4988 25.3899 -18.2163 -19.9205 28.2208 +7126 4 1.89428 18.9873 26.0273 4.60516 17.0002 -8.33323 +7127 4 2.55045 18.8717 24.6878 9.48029 -1.77855 -17.0048 +7128 6 40.6027 8.48954 5.10826 -27.6355 -21.4881 -13.6167 +7129 4 40.6592 9.31425 5.57088 10.9479 16.5697 14.8472 +7130 4 41.3781 7.96424 5.30637 14.4251 2.68711 -2.52113 +7131 6 49.3092 22.3481 41.5186 -9.93734 74.0457 16.0776 +7132 4 48.4971 22.7919 41.1786 21.3857 -10.289 -0.267672 +7133 4 49.2285 21.4633 41.2985 -4.59952 -62.95 -16.8011 +7134 6 0.364483 40.9333 20.5966 -24.8933 -11.8265 -30.66 +7135 4 0.190818 39.9667 20.5681 4.35782 8.08342 1.06674 +7136 4 54.6936 41.3396 19.9676 13.1862 -7.22974 19.6204 +7137 6 34.8864 15.3279 38.0452 -17.1782 37.3505 -55.2903 +7138 4 34.2682 16.0872 37.9321 5.94042 -16.3876 6.60377 +7139 4 35.3697 15.4116 37.1797 -1.56134 -6.74346 24.1748 +7140 6 7.76223 25.9987 29.8652 25.7268 -8.51605 -4.95409 +7141 4 8.61839 26.4638 29.9588 -13.1921 -1.71741 1.7916 +7142 4 8.05672 25.0651 29.9772 -19.4202 16.3818 3.54783 +7143 6 40.7182 22.7954 20.4441 37.8127 13.8011 -33.8007 +7144 4 41.3586 23.4588 20.0133 -28.9149 -26.2189 23.8294 +7145 4 40.2017 23.2969 21.0583 -10.7099 15.3396 13.8501 +7146 6 37.6932 25.6399 36.0638 4.62997 10.0285 35.1853 +7147 4 38.3287 24.9236 36.1183 -2.20273 -4.01008 -9.65359 +7148 4 37.2914 25.6394 35.2107 -7.09628 -5.12362 -31.4654 +7149 6 5.46101 24.0014 10.2586 17.9799 16.5872 6.22131 +7150 4 6.04134 23.844 9.49543 -11.5162 -2.35388 5.85767 +7151 4 5.90746 24.7967 10.672 -23.415 -30.7572 -16.8601 +7152 6 48.4104 21.0451 38.1819 10.5351 27.9197 -28.7006 +7153 4 48.793 20.7803 39.017 13.2175 -6.38321 0.209366 +7154 4 49.1228 21.3802 37.5459 -28.8109 -18.4864 30.6779 +7155 6 15.2906 25.011 3.54101 2.70625 6.69817 -9.95824 +7156 4 15.4569 24.0555 3.50682 -9.52162 -0.514188 6.9158 +7157 4 14.6826 25.2483 4.2581 -1.83637 -10.9582 1.3864 +7158 6 46.3949 40.2718 20.0841 3.05266 -42.5213 0.389481 +7159 4 46.7282 39.319 20.1688 -17.5494 37.8624 -2.40649 +7160 4 47.138 40.8016 20.3323 14.2597 18.5668 -0.122304 +7161 6 34.6662 36.4732 0.324161 -52.0076 35.1593 -1.38074 +7162 4 34.82 35.9689 1.09464 17.4812 -18.6855 30.1307 +7163 4 33.7817 36.8781 0.601954 33.7085 -7.09846 -24.72 +7164 6 52.5968 8.00424 30.4116 -30.791 -5.83914 -1.44892 +7165 4 52.0396 8.66036 30.8559 12.8564 7.40177 -0.477247 +7166 4 51.9287 7.58179 29.8369 22.2614 -6.63703 0.63559 +7167 6 32.0772 3.86049 29.4688 -16.0025 -7.01815 -35.05 +7168 4 31.5382 3.03776 29.5615 20.8838 14.671 -1.22835 +7169 4 32.0904 4.03293 28.4798 -1.86833 -11.5506 40.3284 +7170 6 20.363 17.8245 28.646 3.47804 13.7512 -7.92665 +7171 4 19.5516 17.4966 29.0653 6.53113 9.74715 -6.36853 +7172 4 20.0825 18.3002 27.8308 0.555567 -8.90179 15.8758 +7173 6 30.4041 41.1634 41.0132 -16.7253 12.0993 -9.83452 +7174 4 30.5197 40.835 40.1072 4.71307 -5.7925 7.34595 +7175 4 31.1703 40.9637 41.5368 18.7313 -7.07732 1.06037 +7176 6 35.4542 32.8539 27.9215 21.6406 26.5455 -21.3275 +7177 4 35.1435 33.2362 28.7432 -6.21594 5.85967 7.97646 +7178 4 35.8745 33.6007 27.3754 -13.2283 -32.0923 16.9769 +7179 6 14.39 6.67952 12.731 -12.5058 36.491 0.424373 +7180 4 15.2321 6.28981 12.9462 8.74388 -6.1299 -2.75421 +7181 4 14.5067 7.66796 12.7988 -3.69921 -34.1177 -6.56265 +7182 6 41.8739 41.5433 20.319 24.4238 12.2951 6.29746 +7183 4 42.7192 41.2715 19.9184 -11.0628 6.38436 -6.30872 +7184 4 41.3184 40.7767 20.2955 -10.4459 -12.1473 -5.48062 +7185 6 46.3985 22.5739 8.8638 6.84921 19.3184 1.79378 +7186 4 45.8729 21.8991 8.42669 -3.07803 -12.5032 3.12866 +7187 4 47.1271 22.1566 9.33065 -8.50589 -8.34396 1.5145 +7188 6 17.4023 20.6526 13.9004 10.6995 28.5611 -11.4854 +7189 4 17.6978 21.6036 13.9579 -8.84666 -31.3302 7.07381 +7190 4 17.3123 20.5004 12.9448 0.490636 -3.23538 4.08121 +7191 6 8.20126 9.48382 13.3485 -42.4293 41.8522 17.2798 +7192 4 7.44487 10.0964 13.6076 19.5538 -29.8853 -13.4391 +7193 4 8.9576 10.0119 13.6277 13.7224 -9.45646 -1.54211 +7194 6 7.58554 14.8008 29.5824 -2.61798 9.90858 -2.64866 +7195 4 7.05733 14.3538 30.2458 -0.514214 1.68252 7.63674 +7196 4 7.01989 15.5029 29.2149 4.91731 -6.06465 -0.976267 +7197 6 29.5668 39.2268 22.6285 -3.66094 -2.39634 13.3419 +7198 4 29.8353 38.7557 23.4169 -4.20308 -7.76017 12.2752 +7199 4 30.3745 39.2765 22.1369 12.5997 4.36069 -18.8462 +7200 6 19.725 28.7952 8.44488 15.8543 2.58223 -4.45186 +7201 4 19.5131 27.8757 8.63421 -2.81313 1.38303 -4.16069 +7202 4 20.6983 28.808 8.54393 -13.7447 6.84799 3.59225 +7203 6 20.0995 21.6275 25.9249 -17.5249 50.4223 5.09745 +7204 4 20.7082 22.0204 26.5908 -8.84326 -18.264 -10.6066 +7205 4 19.3931 22.3347 25.9239 13.215 -30.9895 -3.48111 +7206 6 12.7711 16.1006 22.7986 17.0661 -2.75106 -3.7002 +7207 4 12.1316 16.7784 22.5952 -11.3059 6.43976 -4.8982 +7208 4 12.4647 15.3033 22.3372 -2.13756 9.04884 6.71194 +7209 6 7.09175 27.2069 17.991 -23.617 26.2366 -1.29155 +7210 4 7.8076 26.6007 17.9383 20.2011 -26.8554 -5.74897 +7211 4 7.19403 27.792 17.2318 3.33647 -0.0238245 -0.788587 +7212 6 32.3975 8.68618 34.8629 3.54321 22.8272 16.3539 +7213 4 32.7738 9.06402 35.707 -18.9002 -9.48773 -27.5474 +7214 4 31.4989 9.0701 34.6771 23.7457 -9.58556 9.46102 +7215 6 50.3515 28.2186 17.5351 -6.87553 0.519429 12.9107 +7216 4 50.2481 27.3572 17.999 6.5408 9.8464 -12.2276 +7217 4 51.0722 28.1417 16.8919 -2.26653 -7.3618 -1.59066 +7218 6 15.6741 32.1546 25.7968 -26.4348 -11.0143 -14.9159 +7219 4 16.4004 32.6083 26.1805 24.7846 13.6092 10.6573 +7220 4 15.1411 32.8481 25.3674 4.92309 -4.07512 11.5217 +7221 6 41.2877 22.001 29.6411 43.1174 -21.5596 15.2505 +7222 4 40.6305 22.5901 29.3541 -33.8214 23.827 -16.0773 +7223 4 40.8662 21.2212 29.998 -7.36398 -2.60921 4.02408 +7224 6 24.5416 12.7608 8.88206 5.17198 -11.9982 -20.3907 +7225 4 24.1774 13.5122 9.35398 1.69504 4.6425 -2.53241 +7226 4 24.2888 12.8675 7.94212 1.28664 -3.68024 15.0016 +7227 6 47.3025 20.1085 10.3977 1.21439 24.4816 37.2747 +7228 4 48.204 20.4596 10.4656 -0.7364 -8.12719 -10.3932 +7229 4 47.15 19.5905 9.61989 6.68365 -16.152 -23.0167 +7230 6 17.6916 14.2112 29.9613 0.736848 4.98565 -22.9932 +7231 4 16.8377 14.622 30.0672 -16.7241 9.37988 10.4211 +7232 4 18.1183 14.7557 29.2835 1.70081 -6.05446 6.16757 +7233 6 21.3481 34.5805 28.5342 -9.54463 9.82799 -20.865 +7234 4 21.5933 35.4178 28.0943 -1.05427 -4.62886 14.5387 +7235 4 21.7361 34.566 29.3968 13.4346 0.0141216 16.9261 +7236 6 35.1024 4.03924 4.01172 -45.5158 42.5484 12.3245 +7237 4 34.1858 3.89939 4.38295 32.1954 -12.7538 -7.33111 +7238 4 35.1016 5.02916 3.89259 9.91862 -26.8751 2.91657 +7239 6 29.9059 8.58368 22.6013 -13.5917 -22.6535 -48.6732 +7240 4 29.4773 8.30259 21.7189 15.3855 19.7125 42.6195 +7241 4 30.4378 7.8025 22.8052 -0.87874 9.41284 8.39762 +7242 6 9.78314 32.9658 15.9197 34.9354 -36.2496 39.6827 +7243 4 9.8463 32.0623 16.3137 -14.5131 14.3099 -26.4053 +7244 4 10.4229 33.3707 16.5321 -2.5459 17.7355 -14.0184 +7245 6 24.9212 14.2335 32.582 19.5351 -17.8621 25.1352 +7246 4 25.485 14.4356 33.3711 -14.9506 -0.509299 -20.0473 +7247 4 24.5508 15.0526 32.2925 -5.32053 16.7872 -6.18619 +7248 6 49.6539 21.965 26.2345 44.0267 25.2751 -8.97422 +7249 4 50.4399 21.435 26.5572 -22.3889 20.3635 -4.11669 +7250 4 50.0214 22.8598 25.9362 -18.5294 -37.2714 15.3372 +7251 6 39.2165 29.6282 28.7804 -1.72389 1.82743 -9.11301 +7252 4 39.3036 29.0201 29.5259 1.24025 -1.09654 1.55877 +7253 4 39.538 29.1266 28.0158 0.286751 -1.49672 5.82908 +7254 6 50.6899 34.7862 39.7499 25.3157 10.1005 12.0928 +7255 4 51.6472 34.6743 39.5192 -19.7186 -4.86584 -0.193213 +7256 4 50.1651 34.2508 39.1591 2.72681 -14.2758 -14.8682 +7257 6 29.2004 20.8742 19.5261 27.9811 -3.68804 20.7377 +7258 4 30.1466 21.1247 19.5553 -9.39276 -2.96688 2.79863 +7259 4 28.9246 21.1497 18.6738 -22.5466 15.5983 -24.0329 +7260 6 45.8438 1.42491 21.3861 -37.1737 6.40486 -10.0566 +7261 4 44.9885 1.11968 21.7285 6.97513 -0.0444158 -7.72874 +7262 4 46.4438 0.92117 21.8904 34.782 -15.8409 16.3481 +7263 6 26.1011 5.84859 12.9885 -16.9285 4.46913 -7.38549 +7264 4 26.5547 5.08441 12.6375 7.71787 -14.9735 6.0022 +7265 4 25.1614 5.66972 12.8036 4.71997 0.43883 -1.19571 +7266 6 9.00669 19.0403 23.7238 12.8928 30.373 -14.6892 +7267 4 8.06593 18.9071 23.7945 -12.9763 -5.98489 5.20443 +7268 4 9.0473 19.9093 23.2431 5.0983 -22.172 6.64837 +7269 6 47.6961 14.1782 40.0269 19.0377 9.97795 -11.4729 +7270 4 48.5222 14.3512 39.5239 -16.7083 -4.37767 10.6105 +7271 4 47.3795 15.0553 40.2888 -5.04524 -6.44815 -3.81417 +7272 6 47.9985 19.7874 0.500962 -66.9165 -27.0064 -39.4066 +7273 4 48.5513 19.9496 1.22397 26.1904 -2.55385 45.3318 +7274 4 47.2789 19.103 0.704655 34.6798 29.0788 0.973802 +7275 6 27.1606 39.6013 31.4318 -10.4761 -55.491 -38.6851 +7276 4 26.8926 40.2811 32.0159 -13.7359 20.3686 20.1783 +7277 4 26.3709 38.9998 31.2101 25.3937 25.349 18.055 +7278 6 20.7209 15.2822 27.3078 -0.805435 -7.71632 -8.78017 +7279 4 19.7876 15.3781 27.0487 8.25469 13.9731 2.34115 +7280 4 21.2532 16.0335 26.9925 -16.2498 2.55153 -4.46604 +7281 6 53.2722 3.12643 19.6849 41.3384 49.6686 7.26214 +7282 4 52.533 3.74254 19.7043 -8.02663 -2.92583 -3.0848 +7283 4 53.0086 2.23956 19.6703 -22.4403 -46.3419 -2.11618 +7284 6 40.7531 33.3786 24.0219 13.5521 -1.60379 23.9632 +7285 4 41.5067 33.1664 24.6167 -8.75803 3.71621 -14.936 +7286 4 40.1104 32.6626 24.1628 3.50492 2.6284 -2.95087 +7287 6 50.2066 37.8896 21.3771 44.4561 61.7722 -19.2089 +7288 4 50.9779 37.3435 21.496 14.3962 -14.5259 7.12428 +7289 4 49.4598 37.4098 21.5582 -59.0635 -51.549 13.7135 +7290 6 41.3233 2.3412 21.9924 -16.3503 12.7858 19.6024 +7291 4 41.3426 2.52207 21.0679 5.97541 2.4567 -21.4637 +7292 4 40.4663 2.75609 22.2585 17.532 -18.0725 0.252127 +7293 6 3.68867 21.2779 14.3383 -14.5707 42.5 -35.9941 +7294 4 4.12477 21.855 14.9587 9.56216 12.6885 8.47194 +7295 4 3.77328 20.4352 14.6935 9.76412 -50.205 23.6517 +7296 6 34.2782 11.1533 36.6146 -6.03132 -23.9347 13.7336 +7297 4 33.9924 10.5436 37.3334 13.9996 -4.78487 -21.5854 +7298 4 34.1172 11.978 37.0322 -7.62349 27.2634 9.28858 +7299 6 24.0533 21.9225 23.4615 4.73517 -5.47775 13.1649 +7300 4 23.9978 21.53 22.5886 6.00444 -6.53009 -8.74438 +7301 4 24.605 21.2935 23.9896 -10.4931 14.2472 -9.63662 +7302 6 18.8931 0.346665 4.41951 -1.70081 19.9518 7.76538 +7303 4 18.8368 41.3461 4.13842 4.04101 -8.25805 2.22226 +7304 4 19.3845 0.416823 5.25819 -4.2619 -8.11151 -12.0763 +7305 6 1.61167 7.82777 17.7295 14.4633 -7.55708 2.21629 +7306 4 1.68315 6.88308 17.5181 0.421421 7.02752 -3.81945 +7307 4 0.776664 7.94842 18.1735 -9.56642 1.01884 2.20602 +7308 6 9.88587 31.542 26.4865 27.4574 -58.0414 -32.6279 +7309 4 9.74723 30.8294 25.7579 9.18818 32.443 34.13 +7310 4 9.16596 32.1271 26.4328 -35.6644 31.0992 -1.66616 +7311 6 46.989 33.006 20.3636 -11.9681 -37.8677 44.1235 +7312 4 47.0707 32.5253 21.2626 7.56487 31.1056 -35.1941 +7313 4 46.435 32.3629 19.8924 4.61548 9.19147 -10.8851 +7314 6 49.5457 29.2916 21.3977 -38.7846 4.15079 -24.0209 +7315 4 50.3477 28.8236 21.2219 24.323 -7.55681 13.7085 +7316 4 49.5468 29.8542 22.1736 14.9668 -0.936193 10.2574 +7317 6 13.5153 31.8979 19.1528 13.8675 8.3184 29.6787 +7318 4 12.8458 31.9825 19.8587 16.0999 2.21739 -7.32054 +7319 4 14.3406 32.2634 19.5906 -25.0701 -6.26478 -24.6616 +7320 6 46.633 34.1066 16.9257 -0.036059 -36.1463 20.7227 +7321 4 46.8492 33.9929 15.9997 3.99258 8.43366 -10.882 +7322 4 46.9059 33.2223 17.3084 -4.9703 29.3867 -9.59361 +7323 6 19.7609 39.5392 2.42166 -7.20248 -0.896063 -14.0911 +7324 4 20.5606 40.0527 2.5788 -3.5749 4.99115 -1.28658 +7325 4 19.2738 40.0463 1.72337 11.6568 -15.7424 21.4794 +7326 6 16.5329 9.39795 28.3065 -12.6095 -8.72502 6.68605 +7327 4 16.4075 10.3536 28.3648 10.1088 3.80195 -3.74389 +7328 4 17.4502 9.20269 28.1082 11.2813 2.72217 -1.81406 +7329 6 3.0433 33.3643 8.96425 -4.92886 23.6682 -21.9772 +7330 4 2.41869 34.0757 8.74286 -2.57616 0.180013 17.6579 +7331 4 3.16376 33.0029 8.08154 7.55925 -16.3918 2.91827 +7332 6 49.6751 28.308 0.201579 -29.5359 7.30765 2.58258 +7333 4 50.5733 28.3754 41.8671 34.4717 0.327786 -9.88202 +7334 4 49.5726 27.4715 0.657175 -2.26504 -2.01296 8.34302 +7335 6 1.41619 6.84354 30.4994 -10.3235 0.0954103 3.42179 +7336 4 1.63397 7.74222 30.8225 4.19995 -13.4757 3.05915 +7337 4 0.761793 6.45905 31.124 14.5617 20.0187 -8.0296 +7338 6 19.7679 9.42131 33.717 -3.22882 -6.25654 -44.8315 +7339 4 19.9145 8.46604 33.7746 1.8774 1.59257 2.48781 +7340 4 19.5751 9.55831 32.7323 1.24521 6.76178 40.819 +7341 6 26.1724 11.919 3.61074 17.7641 10.7445 -19.8393 +7342 4 25.5356 12.1934 4.24073 -14.9718 14.8208 22.8097 +7343 4 26.0423 10.983 3.54915 1.55706 -20.7566 2.99847 +7344 6 33.2542 2.1444 18.2116 -1.15587 48.9982 3.93816 +7345 4 32.886 2.96086 18.6548 6.67205 -21.4839 -22.8104 +7346 4 32.6761 1.46025 18.493 -13.9253 -19.4899 6.26155 +7347 6 1.55797 29.1194 15.6221 -22.3111 36.2637 61.7506 +7348 4 0.853719 28.5449 15.936 -7.71843 6.28063 0.384394 +7349 4 1.90648 28.6788 14.9107 30.7784 -39.3832 -62.5327 +7350 6 41.7311 4.10421 39.5944 -40.7328 36.7616 -42.7174 +7351 4 41.3817 4.81242 38.923 27.6667 -38.3892 36.6931 +7352 4 40.9025 3.64602 39.8145 11.2401 -8.56921 5.26404 +7353 6 28.6823 41.7982 21.1955 47.2047 1.42594 -8.59686 +7354 4 29.177 0.720645 21.3267 -21.6507 -0.473723 0.486784 +7355 4 29.4617 41.2314 21.0003 -26.4876 -3.65191 3.02858 +7356 6 11.643 12.3982 35.4482 -35.2927 22.3423 -20.2863 +7357 4 11.5968 12.2307 36.3713 6.75035 -5.55932 30.2124 +7358 4 12.5522 12.401 35.2267 32.0712 -2.0845 -6.40416 +7359 6 9.80556 12.056 0.297197 42.0735 31.0338 -28.3715 +7360 4 10.6577 12.4693 0.65483 -33.0881 -22.384 -10.4034 +7361 4 9.20254 11.76 0.941289 -12.1624 -10.8407 36.4861 +7362 6 48.1632 12.393 9.2137 2.43833 7.21341 -5.5951 +7363 4 48.4522 11.811 8.50685 -9.57081 -7.25037 -8.94466 +7364 4 48.8896 12.3474 9.83523 7.41749 2.43397 12.8852 +7365 6 20.1331 24.378 18.9556 11.9182 2.36756 -38.9603 +7366 4 19.4372 23.8368 18.5171 17.2732 8.77886 9.60074 +7367 4 20.7988 24.6336 18.2364 -23.7637 -10.2166 26.3276 +7368 6 16.5494 31.2838 16.4573 -15.9423 3.69088 33.2062 +7369 4 16.5519 32.1922 16.7594 11.1434 16.9832 -11.781 +7370 4 16.1476 30.8867 17.2522 1.55385 -15.8871 -15.2552 +7371 6 1.78983 14.6435 36.2904 4.99553 5.58283 2.2492 +7372 4 1.04893 14.2282 35.8708 -13.8588 -3.35469 -16.6141 +7373 4 1.66905 14.392 37.2023 2.39459 2.07051 19.2387 +7374 6 4.37166 29.2153 29.5914 5.79168 20.1405 -19.3585 +7375 4 4.91557 28.7254 30.2154 7.17051 0.117226 5.39869 +7376 4 4.91513 29.9512 29.1891 -14.7291 -26.607 12.32 +7377 6 43.6969 0.237019 22.6594 -7.19613 -4.49497 -5.57098 +7378 4 43.0237 0.783547 22.2316 -12.2242 -6.81623 2.03469 +7379 4 43.4415 41.2053 22.5454 5.15142 14.113 -1.35906 +7380 6 52.5052 40.9917 27.2414 -4.0762 -16.2903 -30.037 +7381 4 52.8129 40.7577 26.3208 -10.5132 10.5144 20.9332 +7382 4 53.295 41.2999 27.6882 6.37269 9.42971 1.77711 +7383 6 25.5785 23.9088 27.7352 -29.163 -0.147769 2.09076 +7384 4 24.7169 24.3904 27.6009 26.0068 -16.0483 4.45096 +7385 4 26.303 24.4711 27.4736 4.98376 5.99744 -3.44082 +7386 6 23.1322 17.0409 33.3147 -4.87562 4.34963 6.5261 +7387 4 23.1435 17.5188 34.1474 -0.665908 -2.26574 -1.07751 +7388 4 22.9237 16.1327 33.5379 -5.85649 -9.89669 4.05086 +7389 6 2.9235 11.8719 21.3628 -62.5775 -31.8178 -28.2901 +7390 4 2.1985 11.2347 21.6738 31.4392 30.9604 -16.9464 +7391 4 3.51176 11.9111 22.066 35.7266 4.49799 37.8533 +7392 6 2.17958 4.14491 30.0321 9.06251 -9.53771 -13.2585 +7393 4 2.15165 5.09682 30.107 -1.56529 16.7016 0.150815 +7394 4 2.7299 3.97467 29.2422 -7.5281 0.377543 4.10315 +7395 6 26.6694 30.2855 13.4776 10.1196 11.7228 27.7054 +7396 4 25.7357 30.4785 13.6549 -0.51692 -11.2356 -3.98914 +7397 4 27.0778 30.3597 14.373 -6.55394 -4.70072 -25.9179 +7398 6 24.8731 30.8123 10.8246 -35.9544 -8.06722 -7.65859 +7399 4 25.2097 30.0125 10.4324 5.41746 -9.73411 -7.41209 +7400 4 25.6149 31.228 11.1936 31.2673 18.7081 18.3938 +7401 6 53.1638 24.1184 4.51161 -10.4445 -35.9395 21.0824 +7402 4 53.5233 24.7957 3.98549 14.2054 30.1141 -21.0763 +7403 4 53.9237 23.6117 4.81383 2.71167 2.31883 7.09562 +7404 6 24.8958 4.51213 23.9931 -29.6363 -43.6073 15.3227 +7405 4 24.1339 5.1036 23.9039 18.5944 16.8193 -2.99678 +7406 4 25.7258 4.88904 23.7461 22.8138 27.5954 -9.18982 +7407 6 34.6838 1.65591 41.2514 12.8053 -23.083 -29.6978 +7408 4 35.6244 1.45761 41.0729 -14.4971 0.421146 -0.177754 +7409 4 34.7301 1.99199 0.211928 -2.47028 17.9107 34.9925 +7410 6 13.312 19.5249 16.387 18.9594 -19.3284 17.3248 +7411 4 13.9333 19.1674 15.7225 -9.24732 -4.9188 0.52103 +7412 4 13.2597 18.8166 17.0929 -3.23838 18.5958 -24.3952 +7413 6 48.698 0.181353 20.409 -0.21633 -26.9433 -24.4133 +7414 4 49.103 41.5184 19.698 -4.34753 24.5911 30.5043 +7415 4 48.7986 41.623 21.2469 8.80211 1.41451 -0.511645 +7416 6 43.0644 27.7916 11.5133 -14.5871 -6.12813 -9.0892 +7417 4 42.6 28.0105 10.6776 10.2055 -1.97818 11.3293 +7418 4 43.4908 28.591 11.8257 3.55806 4.66568 -1.20709 +7419 6 25.6909 21.365 35.1834 16.6334 21.4278 -26.2382 +7420 4 25.8486 22.0441 34.4664 -6.54449 -15.4554 28.1071 +7421 4 25.5413 20.5536 34.6727 -4.24699 7.33591 15.2905 +7422 6 44.7232 4.60607 27.7619 9.66663 0.618053 -4.25407 +7423 4 44.3234 4.00717 27.1079 -6.11804 2.34462 0.765623 +7424 4 44.3971 5.50639 27.5932 -3.06611 -6.30885 -0.545657 +7425 6 41.2897 11.4432 34.2066 -9.61739 21.0206 -8.56292 +7426 4 40.6842 11.5664 33.4581 3.14959 1.41378 -1.0752 +7427 4 41.1924 10.5195 34.3892 0.589219 -23.8889 7.33677 +7428 6 19.897 36.6492 2.04794 -32.5825 5.5481 -21.6378 +7429 4 20.6399 36.2361 2.4987 10.0826 10.558 0.716761 +7430 4 19.9026 37.6342 1.97212 14.9366 -15.8518 15.2433 +7431 6 27.4836 4.66736 6.35028 2.97665 -65.4375 -50.0742 +7432 4 27.6123 3.82169 6.79207 -3.46759 -4.72632 -9.32934 +7433 4 27.4741 5.24116 7.04108 -4.39889 64.7262 58.0755 +7434 6 16.8382 30.7844 39.9326 10.6925 -56.0648 15.7324 +7435 4 17.0186 31.2572 40.7403 -2.33579 15.7179 12.0581 +7436 4 17.0831 29.8382 40.1617 -5.04661 27.4351 -11.6424 +7437 6 51.1641 15.1933 16.3324 21.7581 16.0625 -9.079 +7438 4 51.121 16.0888 15.8936 10.5188 -25.5533 9.6052 +7439 4 52.0677 14.7794 16.1385 -37.3149 17.1399 3.28502 +7440 6 49.9904 21.2241 35.9744 20.9503 -33.7397 19.542 +7441 4 49.3714 21.5088 35.3291 -23.4605 10.1211 -23.8745 +7442 4 49.9121 20.2362 36.0002 2.40052 26.2853 0.00810801 +7443 6 34.428 0.14016 5.66944 -7.82493 37.3161 8.31948 +7444 4 34.304 0.843366 6.34479 2.68801 -11.9822 -16.4886 +7445 4 34.2591 0.582485 4.80419 9.04141 -16.6905 11.7821 +7446 6 48.3182 11.536 19.8764 -48.9228 13.3726 26.2823 +7447 4 47.7285 11.3649 20.663 34.2262 -2.74449 -19.9886 +7448 4 47.7235 12.1441 19.3775 23.4884 -14.873 -2.11476 +7449 6 4.19152 39.4305 13.3555 27.463 28.0369 44.5079 +7450 4 4.88401 39.7456 14.019 -21.6239 -15.7277 -33.754 +7451 4 3.37287 39.6897 13.8148 -3.76347 -10.7833 -11.4512 +7452 6 8.74995 16.191 8.53596 -5.05856 2.64204 -21.058 +7453 4 8.7323 16.8633 9.22906 0.669847 -0.203387 -6.91741 +7454 4 8.69158 16.6347 7.64451 3.76071 -7.46014 24.9197 +7455 6 29.0285 14.2822 26.5262 -5.84817 34.0816 17.5192 +7456 4 29.0044 15.2824 26.745 3.30971 -49.1818 -9.92417 +7457 4 28.1563 13.9159 26.7584 2.39554 12.59 0.416474 +7458 6 27.3852 14.5292 8.14264 -25.3608 8.37865 0.80053 +7459 4 26.4121 14.3996 8.08331 21.4517 0.6706 1.76752 +7460 4 27.495 15.4908 8.29449 3.73212 -17.2528 -1.50339 +7461 6 14.1265 27.2071 32.922 33.1666 19.82 -10.1122 +7462 4 14.9257 27.349 33.4618 -9.56175 -2.66902 -6.75133 +7463 4 13.49 26.8422 33.5082 -21.5238 -13.7689 15.9353 +7464 6 31.6534 35.7886 21.2701 -36.804 -37.663 0.546332 +7465 4 32.1208 36.3742 21.8378 9.4961 28.0075 13.3964 +7466 4 30.8651 35.4592 21.7961 25.8489 11.2411 -16.1565 +7467 6 54.2152 28.7064 16.8886 2.86275 11.2554 8.9719 +7468 4 53.522 28.534 16.2345 -0.160695 -4.94794 5.34414 +7469 4 54.0581 29.6054 17.2296 -4.68599 -7.1814 -6.41975 +7470 6 9.06113 5.28333 17.1437 22.8853 4.22723 -20.1716 +7471 4 9.91678 5.17464 16.6036 -37.1561 0.754494 23.2593 +7472 4 8.77829 6.22091 17.0709 7.89423 -13.2605 2.73354 +7473 6 29.6746 9.78112 26.5507 33.4729 -21.3737 16.6755 +7474 4 30.5187 9.26436 26.5785 -19.9088 14.0899 -1.39861 +7475 4 29.3838 9.79264 27.4752 -2.64272 0.36338 -0.771294 +7476 6 44.0224 31.1718 32.1785 -15.3292 -7.28341 -3.2168 +7477 4 43.2245 30.9732 32.7283 18.2556 6.42044 -7.39667 +7478 4 44.6106 31.7763 32.6435 0.791193 1.46174 13.5451 +7479 6 53.5017 3.62335 25.1421 -16.9806 -9.67341 -1.19546 +7480 4 54.1073 4.37139 25.2408 5.33888 -0.871569 -8.36925 +7481 4 53.4976 3.25444 24.2353 14.6771 10.8199 10.1585 +7482 6 12.4523 22.8699 3.37515 20.8696 32.0548 51.3092 +7483 4 12.8715 22.0381 3.24611 3.69599 -28.8916 -15.1378 +7484 4 11.7545 23.0169 2.77653 -28.9409 -2.61743 -32.5554 +7485 6 39.4163 29.6883 0.716973 23.965 14.7498 -4.51132 +7486 4 39.9876 29.0776 0.254063 1.0023 1.05593 -7.22278 +7487 4 38.7356 29.138 1.03498 -27.9991 -12.2746 11.9106 +7488 6 13.7523 37.8126 23.0391 19.0421 33.8918 15.0049 +7489 4 14.5819 38.1972 23.3968 -5.92503 -31.5844 -9.82397 +7490 4 13.2717 38.649 23.0641 -23.8611 -10.9328 -14.9892 +7491 6 33.3489 41.2294 0.00543 12.0778 19.0207 4.12226 +7492 4 33.8966 0.076279 41.545 -17.8654 -16.3366 26.9287 +7493 4 33.5442 41.0956 0.968664 -4.79835 4.63337 -24.688 +7494 6 15.7246 3.52046 6.32841 10.9162 -8.85937 41.3038 +7495 4 14.9211 3.23468 6.78447 -0.787572 2.77727 3.3355 +7496 4 15.4617 3.69817 5.45032 -11.5336 7.63209 -33.5323 +7497 6 27.7759 30.762 5.08277 5.52432 -34.0682 -16.3389 +7498 4 28.5998 30.6312 5.57248 -10.7862 7.58152 2.34054 +7499 4 27.6688 29.856 4.68367 -5.5152 22.3618 6.77689 +7500 6 13.3283 7.58248 23.3427 28.3072 -1.43357 14.0598 +7501 4 14.1858 7.86415 22.9596 -10.8574 -4.57961 9.77565 +7502 4 12.7328 7.50745 22.6198 -18.1881 0.025746 -17.8687 +7503 6 38.3062 37.3234 27.9933 -3.63803 -3.21002 47.0561 +7504 4 38.1692 37.3862 27.0673 7.32148 -0.46048 -39.7323 +7505 4 39.0245 36.7163 28.2248 2.26391 -1.88339 -8.27891 +7506 6 35.8197 12.5511 12.093 -4.81482 -18.6185 14.0356 +7507 4 35.6024 11.6096 12.0486 2.81432 1.21601 -0.921604 +7508 4 36.2712 12.7262 11.2865 10.3444 9.98072 -18.0035 +7509 6 52.1161 23.0926 41.2793 27.7225 -3.87143 -59.8556 +7510 4 52.4049 23.0393 40.2964 5.44511 3.0042 51.4604 +7511 4 51.1968 22.9093 41.149 -26.7248 -2.75497 17.7375 +7512 6 39.5495 11.6692 16.6079 -1.17202 -14.5197 -14.1262 +7513 4 39.7784 10.7494 16.7482 7.99576 -7.98247 -12.1867 +7514 4 39.4663 11.9292 17.5115 -4.38422 20.0879 20.6825 +7515 6 0.676885 9.01905 7.96736 13.1741 22.7352 -22.4375 +7516 4 54.8016 8.92404 8.29683 -40.226 7.08621 2.19233 +7517 4 1.10058 8.31451 8.38908 28.7575 -30.4684 16.9583 +7518 6 42.3311 28.7401 39.4661 13.4879 80.877 11.2525 +7519 4 41.6603 28.5849 40.0851 -34.7426 -11.2721 27.5092 +7520 4 42.5519 27.921 39.1558 20.2132 -66.4303 -37.3003 +7521 6 38.7411 30.2829 16.2738 12.7671 5.32399 18.4704 +7522 4 38.9183 29.8748 17.1496 -6.87016 4.31697 -11.6029 +7523 4 39.4059 31.0046 16.2472 -14.9795 -12.5163 -3.03567 +7524 6 7.58764 18.0405 0.648325 -47.6574 -19.7672 20.3632 +7525 4 7.12731 17.6217 1.42737 12.1211 9.19751 -27.5752 +7526 4 8.47251 18.0259 0.938181 42.7013 4.4664 8.86021 +7527 6 33.7296 34.5938 24.1405 -3.484 -2.51034 -8.30179 +7528 4 33.5251 35.3309 23.5532 1.13599 -1.72579 4.26838 +7529 4 33.8994 34.9649 25.0137 6.47563 -1.63099 1.09862 +7530 6 16.0166 40.0494 39.5956 -28.3908 0.329345 -1.37751 +7531 4 16.9382 40.2323 39.4336 17.0381 0.329941 -6.23981 +7532 4 15.5262 40.0524 38.7513 12.3223 -0.591958 2.13513 +7533 6 4.49229 37.1333 21.8385 27.3085 -52.2253 -58.5501 +7534 4 4.66683 37.716 22.5264 18.8147 38.5231 40.56 +7535 4 5.37915 36.8768 21.3985 -41.7208 12.465 14.7942 +7536 6 39.2691 20.1288 31.3316 -12.2203 -9.20146 -18.9279 +7537 4 39.1503 20.9416 31.8094 1.95478 16.2675 16.373 +7538 4 38.6746 20.1785 30.5607 4.99665 9.53371 7.24081 +7539 6 28.5508 6.16368 32.0494 2.8072 -5.52183 -6.01527 +7540 4 29.3622 6.49582 32.4253 9.65206 -4.8896 7.96618 +7541 4 28.0782 6.98121 31.874 -4.3704 -0.58129 1.95425 +7542 6 9.33595 11.3298 38.1871 -32.8874 9.84086 11.8913 +7543 4 8.64445 12.0594 38.2922 21.8008 -26.7714 -10.0524 +7544 4 8.88851 10.5546 37.784 7.69784 20.5749 -6.72048 +7545 6 41.6095 10.4782 6.86111 8.23897 -6.62675 34.9169 +7546 4 41.7694 10.1037 7.78655 -4.1265 15.4661 -32.721 +7547 4 41.7821 11.4382 6.90291 -3.49967 -11.9299 -5.09907 +7548 6 3.12867 28.1157 17.6206 15.6267 -45.6796 29.9202 +7549 4 2.63816 28.6493 17.0564 -29.7899 29.6493 -43.0934 +7550 4 3.59757 28.7421 18.155 7.53462 9.15161 11.5693 +7551 6 39.3499 12.2397 19.2529 -23.7838 14.9837 13.9357 +7552 4 39.2457 13.2286 19.3464 7.91877 -27.4185 3.68816 +7553 4 38.6075 11.8387 19.7677 15.6586 5.94778 -12.3856 +7554 6 2.78491 9.11686 31.712 -26.5503 -22.4732 34.9375 +7555 4 3.2978 8.41451 32.2045 -9.27186 19.8876 -17.5091 +7556 4 3.27525 9.5282 31.0263 27.6548 6.40843 -16.0242 +7557 6 47.0993 34.3062 24.1668 40.213 25.5871 3.96938 +7558 4 47.8652 34.9011 23.9742 -8.40565 -28.0457 9.8184 +7559 4 46.4391 34.8642 23.795 -37.1496 -1.08965 -6.28687 +7560 6 41.29 35.6184 9.54316 -30.0867 29.8286 7.21591 +7561 4 40.3249 35.7138 9.72984 17.4159 -14.0538 -3.31523 +7562 4 41.5907 36.542 9.70742 6.71087 -21.892 -10.0971 +7563 6 20.4656 31.4513 3.14505 -29.4444 2.15246 21.5865 +7564 4 20.9799 31.2087 3.9226 8.79014 -0.482357 -2.15716 +7565 4 19.5517 31.5947 3.51954 23.5031 -1.57475 -20.844 +7566 6 33.2192 17.965 24.7971 19.8065 25.0952 18.1835 +7567 4 34.1598 18.0267 25.093 -16.2559 -11.4614 -7.96855 +7568 4 32.9244 18.9016 24.8301 -6.14071 -21.8705 -2.46334 +7569 6 40.1545 39.892 35.7566 -26.4952 1.03865 35.1005 +7570 4 39.554 39.7115 35.0283 3.12548 3.08468 -2.58895 +7571 4 39.5538 40.0617 36.55 23.7339 -1.54775 -30.4418 +7572 6 4.86493 34.7165 16.5037 -1.18866 4.83191 -8.79653 +7573 4 4.98021 35.6639 16.3239 -2.48039 -7.07182 -3.79473 +7574 4 5.57973 34.27 16.0245 9.17482 -2.77359 5.31354 +7575 6 19.1203 11.0308 26.5475 4.8369 12.9311 -1.38474 +7576 4 19.2948 10.8261 25.6303 -10.7878 -2.53157 -9.81197 +7577 4 19.6222 10.3806 27.0285 -0.932765 -12.0852 11.9627 +7578 6 54.013 13.9266 34.7866 19.735 -12.4153 18.0126 +7579 4 53.1377 14.0488 35.1524 -10.4928 -1.09871 -13.0068 +7580 4 53.982 14.1469 33.8595 -3.66316 10.2302 -11.2602 +7581 6 1.83695 20.649 5.20524 25.5491 14.9074 -17.0883 +7582 4 1.35705 19.8566 4.90021 2.5306 9.60758 -2.11708 +7583 4 2.48138 20.9466 4.48633 -27.5057 -15.388 16.1855 +7584 6 22.2484 0.089789 14.2543 15.3573 -11.1234 0.0573231 +7585 4 21.4821 0.622149 14.4313 -9.66168 8.29964 10.305 +7586 4 22.7606 41.8363 15.0657 -14.7435 5.42194 -5.09127 +7587 6 4.9437 7.03924 24.7311 13.2528 -2.19763 7.32506 +7588 4 4.13251 7.3412 24.2993 4.98795 -3.92941 -4.4547 +7589 4 5.31694 6.26419 24.274 -9.7854 5.58222 5.45409 +7590 6 41.4768 20.8727 34.9433 -10.8141 32.3245 17.6117 +7591 4 42.0721 20.1596 35.0936 18.2074 -21.2429 -2.25611 +7592 4 41.5511 21.3995 35.7803 -3.93981 -14.5735 -18.4651 +7593 6 28.2063 1.73787 31.7361 2.56856 -6.63991 -21.6427 +7594 4 27.5833 1.04583 32.0206 5.931 11.5306 2.70007 +7595 4 28.427 2.28487 32.4907 -6.15569 2.19681 12.1249 +7596 6 16.8959 27.3728 36.9936 3.36683 -9.46076 -21.7251 +7597 4 17.1861 28.0765 36.4018 -0.835984 6.87178 9.62195 +7598 4 17.1491 26.5677 36.4964 -8.72142 5.45523 11.8618 +7599 6 26.8172 38.095 8.33253 -7.04389 15.4319 43.7153 +7600 4 26.4231 38.1886 9.22965 13.1827 16.4204 -18.9623 +7601 4 26.752 37.1697 8.26194 2.82704 -45.8494 -18.5449 +7602 6 26.6605 33.8021 23.2109 -14.7721 -8.40788 6.86704 +7603 4 27.1437 33.2455 22.6071 1.71839 -3.83047 -13.3917 +7604 4 27.3181 34.0928 23.8234 13.6598 11.6313 12.8928 +7605 6 10.2089 27.1103 30.2249 26.5091 -20.839 -19.8889 +7606 4 10.2296 28.0525 30.305 -4.35446 23.414 7.17464 +7607 4 10.909 26.9135 29.5485 -17.3927 5.996 19.4297 +7608 6 47.8678 12.6068 5.01236 10.3402 17.2727 14.3835 +7609 4 48.2471 13.4466 5.34357 -15.5974 -13.1618 -9.91905 +7610 4 48.2827 11.9587 5.58273 0.760146 -12.24 2.37579 +7611 6 53.3401 24.5564 22.1447 -33.4845 3.13007 15.4457 +7612 4 53.2868 24.6175 23.1082 -8.50106 -5.88574 1.47389 +7613 4 54.2491 24.6404 21.954 37.9576 4.9603 -12.0283 +7614 6 29.4115 10.751 19.3682 47.3718 16.1602 -3.46693 +7615 4 29.23 9.95501 18.9095 -1.62259 -22.6341 -18.5903 +7616 4 28.6164 10.8767 19.816 -47.8248 15.8998 30.722 +7617 6 39.4772 14.9486 19.552 50.4126 11.9025 42.2912 +7618 4 40.3976 15.2789 19.8627 -47.7598 -21.1435 -8.50237 +7619 4 39.4723 15.2512 18.6704 -12.4406 15.8155 -35.6919 +7620 6 32.8813 15.9868 22.8125 3.47488 17.0872 -31.9433 +7621 4 33.0166 16.4922 23.6113 -1.39335 7.20309 14.6349 +7622 4 32.7144 15.0846 23.0256 -4.37432 -22.045 19.0968 +7623 6 30.558 1.96704 21.5074 2.70654 -4.91402 -0.473851 +7624 4 30.6739 2.00523 22.4671 5.88049 3.20632 -1.97238 +7625 4 31.3728 1.59666 21.1136 -11.8747 6.17773 7.16567 +7626 6 0.976021 12.0022 3.31788 -2.33791 2.9975 -11.3542 +7627 4 1.23381 12.945 3.27167 -8.13702 -10.1344 5.41434 +7628 4 1.05317 11.6593 4.21576 7.83216 6.74936 8.77967 +7629 6 32.1417 30.4028 20.7928 -10.9162 7.90477 -12.8705 +7630 4 32.9583 30.6218 20.3315 4.32484 3.35409 -0.814586 +7631 4 31.4267 30.7883 20.2371 10.7836 -11.8724 10.7529 +7632 6 5.37233 35.5196 8.9984 1.65786 -0.655334 17.0686 +7633 4 5.15633 35.7733 8.10502 -8.52999 -6.98357 -10.434 +7634 4 4.86772 34.7263 9.2434 -1.9757 2.02155 -6.9424 +7635 6 49.9125 13.0387 32.1973 27.4626 15.6741 -16.8517 +7636 4 50.6053 12.9182 31.4733 -26.2683 -0.306922 26.3637 +7637 4 49.2504 12.3613 32.0764 -3.75185 -11.6573 -0.304044 +7638 6 4.31386 24.093 1.57868 7.45772 -24.8618 -14.5348 +7639 4 3.64218 24.7342 1.7864 -13.9986 8.43803 -2.25361 +7640 4 4.01488 23.4668 0.872394 2.3276 24.3041 16.4513 +7641 6 44.1644 38.1215 12.3455 -22.0907 -25.3739 20.9172 +7642 4 43.5152 37.5597 12.8481 16.1408 4.83783 -17.5332 +7643 4 43.8688 38.9961 12.5721 5.21907 21.319 -3.3764 +7644 6 44.6817 17.3326 22.8013 48.0619 -4.56356 -9.07637 +7645 4 45.2902 18.0584 23.1498 -22.5072 -22.7727 -5.21409 +7646 4 45.2932 16.6008 22.4593 -20.015 30.0459 19.1644 +7647 6 20.3678 11.7042 19.6638 18.1083 -41.9451 -24.672 +7648 4 19.8947 12.3606 20.1264 -14.0753 36.8205 14.9866 +7649 4 20.5011 12.0109 18.7433 -0.799123 0.72776 10.7716 +7650 6 4.45477 15.3976 36.1886 1.65809 1.26145 11.9226 +7651 4 5.09661 14.6681 36.098 -4.75494 5.61497 -10.92 +7652 4 3.56051 15.0123 36.2095 4.93474 0.57137 -3.51241 +7653 6 44.8032 39.5214 30.1736 10.2403 3.65831 -28.7798 +7654 4 44.6649 39.352 29.2044 0.893291 -3.4354 28.9244 +7655 4 44.1834 39.0261 30.7164 -9.9549 -0.503639 -4.51595 +7656 6 30.0776 3.52093 11.3186 -8.111 -9.63673 -5.93937 +7657 4 30.5797 4.33725 11.0789 -10.9699 -19.7375 -4.73534 +7658 4 29.9808 2.85663 10.5812 14.022 21.906 10.2093 +7659 6 25.6241 24.8658 16.1333 6.68449 -9.57605 -29.1286 +7660 4 26.5694 24.8046 15.8818 -8.72523 1.1772 17.1704 +7661 4 25.5267 25.1318 17.0381 12.8553 5.85519 26.3055 +7662 6 36.8177 29.8487 20.6561 -37.5479 -3.0004 33.0202 +7663 4 35.926 30.1959 20.4157 18.2985 -1.907 -0.407745 +7664 4 36.6716 29.3784 21.5423 12.7247 15.2026 -39.3319 +7665 6 52.2186 17.0658 38.3042 -7.89215 -38.4825 28.5148 +7666 4 51.4916 16.4675 38.6484 24.7832 21.5941 -14.95 +7667 4 51.8247 17.6139 37.6469 -10.8917 8.73986 -12.7264 +7668 6 3.82879 23.6249 29.8747 0.0111461 24.9347 -0.194649 +7669 4 4.57266 23.2964 29.3507 7.82142 7.55197 5.89536 +7670 4 4.12107 24.4472 30.3626 -2.93665 -31.334 -6.69289 +7671 6 6.37221 19.8955 41.0814 -10.7405 10.6187 0.232117 +7672 4 6.67124 19.2607 41.7286 9.67887 -12.4754 3.81392 +7673 4 6.49825 20.7419 41.4991 -1.14685 10.1205 10.9238 +7674 6 28.9128 38.9237 35.3305 22.4394 21.6131 25.3888 +7675 4 28.4594 38.2476 34.8641 -13.9867 -26.2755 -20.0992 +7676 4 29.711 38.4973 35.7105 -10.7836 3.83713 -8.57645 +7677 6 1.06675 30.3059 34.4729 25.4378 -4.31804 35.0042 +7678 4 0.780778 29.8064 33.7399 -5.76855 -22.7951 -38.2413 +7679 4 0.490797 31.0506 34.5199 -18.1513 16.5028 -0.872558 +7680 6 26.4359 22.0299 20.4363 32.8101 13.5123 0.44111 +7681 4 27.364 22.3315 20.3938 -13.8894 -16.1779 0.0777322 +7682 4 25.9647 22.8561 20.3336 -19.4369 -2.2953 -2.32927 +7683 6 3.94837 18.6341 22.6823 32.7056 -17.0211 23.8668 +7684 4 4.7768 18.6814 23.2391 -24.3494 -8.73456 -16.7413 +7685 4 3.72444 19.5457 22.6416 -13.4357 33.3979 -9.86072 +7686 6 6.89585 39.3162 26.9832 -46.5714 7.68979 7.72716 +7687 4 6.93923 40.0377 27.612 28.7888 3.33438 12.9127 +7688 4 5.92214 39.2413 27.0287 16.4173 -5.75108 -11.0421 +7689 6 43.9872 41.7521 26.5322 17.8857 -12.0416 -16.5154 +7690 4 43.9509 0.2718 27.3768 -8.40653 9.77536 19.5266 +7691 4 43.1315 41.809 26.1188 -22.0408 9.50446 -3.00799 +7692 6 31.7113 29.5746 16.987 -20.6637 1.93471 5.13032 +7693 4 31.02 28.863 17.0135 12.5534 15.6398 -7.64726 +7694 4 31.2508 30.4156 17.2234 10.2038 -24.3383 2.42367 +7695 6 46.2561 10.9612 15.5385 0.577538 -38.7584 22.3134 +7696 4 45.3251 10.7213 15.4484 -5.02058 7.03855 -0.171485 +7697 4 46.6569 10.0824 15.7727 -2.20865 28.2857 -11.3723 +7698 6 36.5827 15.0435 25.8168 31.2067 4.61936 9.12499 +7699 4 37.3875 15.5118 26.1911 -33.209 -18.98 -14.6655 +7700 4 36.1295 14.6889 26.5897 -4.0863 -6.05063 3.58839 +7701 6 47.2722 22.6647 6.13576 -8.17133 27.0247 -35.749 +7702 4 46.6204 23.3224 5.77393 14.8224 -22.4366 13.8178 +7703 4 46.9842 22.4705 7.01441 -4.98592 -2.25738 16.061 +7704 6 27.5378 39.6651 17.8024 -2.94112 10.9701 -10.3343 +7705 4 26.5953 39.7232 17.618 -8.53785 1.10642 -8.0722 +7706 4 27.5664 39.1005 18.5557 5.38052 -12.9364 18.2146 +7707 6 14.0357 27.9675 36.8848 11.7171 -39.9071 2.25396 +7708 4 13.4367 27.1833 36.8225 11.7441 28.4062 -4.63591 +7709 4 14.9372 27.5486 36.8957 -17.1932 18.8386 1.76957 +7710 6 33.7684 13.0304 13.8649 26.1794 -24.2655 -33.187 +7711 4 34.6252 12.938 13.363 -28.3858 22.7045 20.1179 +7712 4 33.4338 12.1329 13.7478 -6.61414 4.24237 14.4002 +7713 6 3.3826 17.477 1.97134 -12.4208 -32.1468 -36.6933 +7714 4 2.99872 16.7111 1.40376 19.9781 39.313 29.0042 +7715 4 3.44044 18.2025 1.33186 0.336883 0.1642 8.16047 +7716 6 27.5407 2.76347 36.4361 37.1152 10.6125 -5.75272 +7717 4 28.1274 2.95293 35.6781 -8.18971 -2.06925 12.0999 +7718 4 26.7696 2.41682 36.0063 -15.232 -6.73967 7.66134 +7719 6 21.3092 1.20818 18.7198 27.6808 -56.7894 17.4302 +7720 4 20.9088 2.03925 18.6129 -17.8717 42.912 1.2548 +7721 4 21.1846 0.863131 19.6413 -10.5106 12.8119 -18.3621 +7722 6 11.8887 16.6751 29.3062 -13.3787 -14.7829 9.57092 +7723 4 10.9992 16.5416 28.8882 19.0949 3.10928 11.6713 +7724 4 11.8781 16.1991 30.1864 -3.15773 18.3703 -25.9576 +7725 6 15.9606 29.4505 29.6321 19.1231 40.0535 19.8704 +7726 4 16.8787 29.2659 29.409 -1.79459 -0.812108 -5.15406 +7727 4 16.0576 30.3074 30.1528 -10.887 -31.0851 -11.0284 +7728 6 42.9296 7.03459 4.51333 33.3286 4.63812 8.33203 +7729 4 43.4321 7.52085 3.82302 -14.3213 -8.56549 9.51251 +7730 4 43.6462 6.74019 5.1384 -26.8219 -5.28882 -15.1101 +7731 6 46.4281 26.3352 18.5118 -29.5226 20.9834 -10.3716 +7732 4 46.6343 27.1839 18.9751 -0.829481 -30.2492 -9.82569 +7733 4 45.6684 26.5824 17.9287 20.9241 -8.5113 7.46212 +7734 6 26.8394 31.9326 30.1088 25.5924 -16.6135 -32.4851 +7735 4 27.2107 31.0232 29.8435 -20.3392 35.4128 12.4615 +7736 4 26.6802 32.4017 29.2373 1.48159 -21.8349 29.7067 +7737 6 19.4878 37.6142 31.2562 -14.4543 3.58951 24.8148 +7738 4 19.156 36.8698 30.7235 -3.28844 3.66685 11.8368 +7739 4 19.1019 37.6358 32.1884 8.87174 -10.6544 -29.6345 +7740 6 52.3726 32.7139 12.8078 14.0751 37.5782 -32.6023 +7741 4 51.9367 33.0602 12.0031 -5.44932 -19.1877 9.81768 +7742 4 53.2329 33.1776 12.7347 -13.6236 -17.9256 14.0183 +7743 6 6.74161 9.28353 24.0307 -13.1667 -36.0519 9.75632 +7744 4 6.38029 9.61276 23.1997 0.718458 -3.76261 -6.90188 +7745 4 6.16941 8.51095 24.2946 11.6474 19.2019 -8.42102 +7746 6 39.7455 39.5612 25.4988 -8.346 1.54154 -0.59194 +7747 4 39.7035 38.6168 25.2826 0.975023 6.38379 0.651723 +7748 4 38.8484 39.7767 25.8082 2.0142 -6.85885 -0.770105 +7749 6 24.0762 14.0053 21.1456 13.3165 -18.5501 -35.6859 +7750 4 23.5798 13.5675 21.8237 -9.9014 -1.44375 19.5869 +7751 4 24.3047 13.2647 20.5221 -3.72657 29.1491 15.9401 +7752 6 5.19759 41.7876 24.8616 10.5329 -30.3401 13.9713 +7753 4 5.96107 0.070496 25.4117 5.01198 -1.48177 -8.04364 +7754 4 4.80364 0.70791 24.6471 -6.87058 19.426 -10.6286 +7755 6 42.3635 20.8692 21.2747 32.7502 -34.6644 -10.1673 +7756 4 42.4242 20.4785 22.1458 -3.583 2.66194 10.2144 +7757 4 41.7418 21.5604 21.318 -29.6652 28.4695 2.24145 +7758 6 48.2477 15.3659 33.5923 1.80889 -1.28345 12.5443 +7759 4 48.6164 14.6993 32.9992 0.330488 0.612282 -4.05403 +7760 4 47.6342 15.9182 33.1009 -4.13716 0.340872 -13.8372 +7761 6 46.021 38.2915 16.5867 23.3569 13.4435 24.034 +7762 4 46.6714 37.7063 17.0526 -15.1447 15.3639 -15.4724 +7763 4 46.2171 39.2064 16.9307 -10.1858 -20.2136 -16.2853 +7764 6 4.64649 28.484 21.3661 -49.4423 -36.8464 -34.122 +7765 4 5.0061 28.857 22.1388 17.5694 9.2675 37.6073 +7766 4 4.11403 27.6656 21.6036 24.8595 24.6655 -3.1651 +7767 6 20.5601 15.1658 18.389 17.6685 -18.4833 12.4376 +7768 4 20.0269 15.9148 18.1339 -10.4277 9.01273 0.992097 +7769 4 20.1375 14.696 19.1318 -1.87864 11.9594 -2.12399 +7770 6 16.2536 13.648 17.4664 -31.6255 -3.12789 -19.3987 +7771 4 16.1444 14.6075 17.6118 2.65347 -13.1818 -8.15029 +7772 4 15.6032 13.3943 16.7283 22.0135 11.6863 31.5082 +7773 6 52.4969 30.9511 18.1582 10.5176 -22.8935 27.2955 +7774 4 52.1187 31.5845 17.5724 -17.5669 13.4893 -21.7562 +7775 4 51.7599 30.5669 18.6706 14.518 10.6779 -8.97027 +7776 6 24.417 1.73185 15.7818 -6.46311 -4.24469 33.4298 +7777 4 24.2563 1.19981 16.5985 3.98325 2.24538 -18.7421 +7778 4 24.1038 2.61269 16.0335 4.13298 0.832539 -9.96215 +7779 6 23.8696 5.09384 31.0808 18.8621 -40.8234 -26.8653 +7780 4 23.8491 5.89936 31.5593 0.144588 30.2314 14.3891 +7781 4 24.8063 4.82715 30.9043 -17.3015 12.7186 6.18451 +7782 6 29.664 30.9246 0.393748 19.8337 -4.81556 23.0674 +7783 4 30.503 30.586 0.018652 -21.3617 6.75777 -1.54054 +7784 4 29.144 31.3327 41.6109 -5.17979 -0.628515 -14.2195 +7785 6 32.8496 37.8945 22.5158 10.0753 4.77658 10.1953 +7786 4 33.692 38.178 22.1563 2.67507 -3.41774 -7.7275 +7787 4 32.953 38.1222 23.4459 -10.6691 2.21895 5.00606 +7788 6 16.4801 17.3789 33.7607 -9.23434 -4.14589 -23.771 +7789 4 15.9446 17.8653 33.093 7.5539 3.01496 23.5583 +7790 4 17.136 16.9338 33.2029 1.0053 3.7812 3.66748 +7791 6 9.22576 13.3955 27.544 21.8484 -6.91303 -4.28818 +7792 4 8.36976 13.4851 27.1157 -15.2219 0.444174 10.4645 +7793 4 9.14931 12.9772 28.4181 -9.36318 7.36421 3.71477 +7794 6 43.4776 7.7356 17.2334 -9.59035 3.82748 19.1182 +7795 4 43.4092 7.74545 18.2218 0.501649 1.62452 -33.0026 +7796 4 44.4173 7.85634 17.0579 0.99974 -1.57098 -4.99047 +7797 6 22.314 24.3423 23.1668 -12.6246 5.51695 -1.93377 +7798 4 22.7955 23.5193 23.2443 6.83464 -10.1031 3.26418 +7799 4 21.5276 24.1384 22.6266 3.35813 5.31764 3.82921 +7800 6 26.0086 32.9187 32.7195 -0.756619 6.65713 -1.20686 +7801 4 26.2515 32.7095 31.8047 -0.82286 -4.52018 -0.557583 +7802 4 25.2078 32.4163 32.9092 -2.81033 -0.378904 -0.617388 +7803 6 16.9305 19.0463 7.44765 14.0068 18.7364 -6.96389 +7804 4 16.3855 19.2981 8.21028 -2.47769 1.30563 -6.88861 +7805 4 17.0815 19.8512 6.87677 -9.59141 -23.4241 18.196 +7806 6 48.1118 14.458 27.5672 -1.70385 5.14823 10.3583 +7807 4 48.0423 15.1786 26.9235 1.90686 -4.78611 -1.19899 +7808 4 48.0875 14.8765 28.4507 4.89589 -0.740891 -11.823 +7809 6 52.3863 41.7399 11.1185 2.41988 14.2085 23.7397 +7810 4 52.3863 0.193993 10.2459 -4.45976 10.8931 -22.0542 +7811 4 52.6887 0.557857 11.7005 -5.56281 -10.4239 -7.84704 +7812 6 36.3311 6.93589 12.7094 -2.38398 9.53491 -1.97617 +7813 4 36.3789 7.90344 12.827 -2.48918 -10.7733 3.15906 +7814 4 37.2588 6.6822 12.6726 5.22435 -7.00461 -0.877062 +7815 6 8.24215 20.3216 16.6719 4.98767 -5.10439 -5.65687 +7816 4 8.08588 19.3952 16.4038 -4.3079 5.82994 10.8424 +7817 4 9.2046 20.4438 16.7199 -1.30961 -3.63404 -4.19262 +7818 6 28.7954 40.3113 12.828 -13.6179 6.23593 21.4452 +7819 4 29.5192 40.3706 12.2287 20.8327 -7.3113 -16.8089 +7820 4 28.5554 39.3777 12.9053 -3.26344 4.60902 -2.65931 +7821 6 18.1473 11.8343 16.9395 -0.80483 -16.2761 12.6256 +7822 4 17.6848 12.6388 17.2294 4.62203 -2.59462 -3.9508 +7823 4 19.0947 11.9922 16.9221 7.13726 16.095 1.27241 +7824 6 30.8869 17.4142 21.504 -52.7305 12.2285 -31.3088 +7825 4 30.1482 16.8222 21.1884 27.1221 10.2955 22.0665 +7826 4 31.6253 16.8731 21.7262 19.9221 -18.6281 13.9623 +7827 6 34.8012 19.4194 37.9626 16.1869 22.0253 -15.6613 +7828 4 34.8979 20.1386 37.2822 -2.41662 -18.1877 20.3873 +7829 4 34.2105 18.7604 37.6043 -6.15487 -8.04615 -10.7113 +7830 6 35.8208 16.8923 29.2032 22.3367 20.7443 33.8648 +7831 4 36.613 16.5252 29.6466 -9.20578 0.119567 -6.22754 +7832 4 35.5382 16.2441 28.5922 -11.4717 -30.451 -21.7041 +7833 6 3.04279 32.2854 6.33929 -26.9238 12.3825 -4.69033 +7834 4 2.12647 32.146 6.0594 1.42689 6.59766 6.64942 +7835 4 3.42261 31.4611 6.08203 25.9982 -20.506 -0.598367 +7836 6 26.7966 41.6596 10.1464 32.6739 -10.8326 9.81865 +7837 4 27.6955 41.4226 9.79016 -25.5431 4.71255 4.81996 +7838 4 26.9918 0.01593 11.0584 -5.4334 2.64263 -3.14356 +7839 6 52.266 24.562 24.8685 -9.42886 0.421982 -6.72882 +7840 4 51.3046 24.7615 24.9057 17.7877 -5.82089 5.23086 +7841 4 52.6568 24.8699 25.6923 -4.67896 5.24225 9.60646 +7842 6 22.6938 22.6511 33.5751 -3.71591 7.58927 38.5179 +7843 4 23.2073 23.1628 34.2375 -1.81825 -3.74423 -24.5931 +7844 4 21.9227 22.4274 34.1227 -1.3969 -6.37714 -14.1968 +7845 6 10.6508 14.2453 33.0462 38.3111 -19.1724 1.31243 +7846 4 10.5904 14.9583 32.4175 -11.7628 10.624 -9.61146 +7847 4 9.79743 14.0525 33.3881 -28.4056 0.15536 2.16046 +7848 6 21.8963 10.8464 11.5207 26.0054 2.65771 10.2946 +7849 4 22.8204 10.615 11.7238 1.04479 5.32162 -7.74354 +7850 4 21.5123 10.8483 12.397 -14.7134 -4.5627 10.8449 +7851 6 38.3602 6.02493 25.8481 -1.65407 -6.16467 0.326828 +7852 4 38.011 6.16356 26.7557 4.19059 11.4538 -13.8011 +7853 4 38.4332 6.8537 25.3449 -2.0709 2.94932 12.5244 +7854 6 30.9335 26.6426 38.5759 12.2579 -6.52521 -50.146 +7855 4 30.9725 26.4832 39.4983 -1.12433 -12.3748 34.5417 +7856 4 31.1634 25.7976 38.1184 -10.2303 12.0451 18.6771 +7857 6 30.1758 14.6176 35.4883 -28.0954 45.5198 -22.6945 +7858 4 30.377 15.4621 34.9933 16.3957 -28.3235 8.82257 +7859 4 29.2055 14.6893 35.4544 11.1506 -16.8188 10.9927 +7860 6 12.5393 37.2199 16.9523 -39.8589 -5.36999 -7.27655 +7861 4 12.8749 37.9509 17.4338 22.3846 22.4284 20.6781 +7862 4 13.1653 36.5135 16.9845 23.2041 -13.3789 -0.375674 +7863 6 27.4265 21.5607 37.7225 20.8747 -12.9562 -0.181201 +7864 4 26.9326 21.725 36.9211 -12.0211 3.79264 -7.84561 +7865 4 27.0206 21.994 38.4656 -12.5008 8.35973 2.85409 +7866 6 29.6119 18.3909 12.6766 5.02953 -16.5769 27.1188 +7867 4 29.5217 18.1084 13.6179 -1.01954 6.11509 -19.9302 +7868 4 28.7057 18.4542 12.3734 -9.03627 4.70036 -1.08008 +7869 6 2.35849 15.6559 0.172343 -13.1317 26.5324 40.4931 +7870 4 1.57628 15.538 41.5798 -33.9312 2.46749 -10.4392 +7871 4 2.94928 15.1153 41.6306 46.9044 -35.3027 -23.6199 +7872 6 17.8239 25.728 4.21905 -37.6117 -8.49993 -31.7596 +7873 4 16.8718 25.6243 3.8952 33.4499 1.9374 22.526 +7874 4 18.2969 25.7387 3.3671 7.88894 5.9968 18.5236 +7875 6 41.8048 11.1855 20.2736 -2.74436 -4.31591 -6.39865 +7876 4 42.499 11.3266 19.6063 -2.31748 -7.213 6.47037 +7877 4 40.9812 11.3277 19.7997 -4.16553 7.78699 0.129723 +7878 6 38.0436 18.3822 24.0291 -8.03771 -8.75406 0.916934 +7879 4 38.3881 19.1147 24.5363 7.93091 8.32946 7.65245 +7880 4 37.8775 18.7197 23.1534 1.15748 3.59885 -9.88254 +7881 6 4.13949 13.9245 33.751 32.8429 -54.5446 -5.73928 +7882 4 3.27676 13.674 34.0388 -19.3763 3.63281 4.9893 +7883 4 4.61955 13.0097 33.6871 -20.752 50.0513 -2.76975 +7884 6 19.1955 19.1942 26.4999 -2.68794 -13.6734 16.0889 +7885 4 19.5301 20.0447 26.2113 2.49975 9.05121 -5.4902 +7886 4 18.8802 18.7176 25.7363 0.91839 -0.338605 -10.966 +7887 6 22.4654 26.212 25.3377 -43.9819 -31.3945 15.8492 +7888 4 22.341 25.462 24.7348 6.987 2.92742 -4.90062 +7889 4 23.2684 26.6111 25.1223 47.0594 15.091 -19.0516 +7890 6 48.8212 32.07 32.5598 -32.6217 13.0764 9.49579 +7891 4 48.8519 31.1339 32.3903 9.77015 -16.5586 -2.94571 +7892 4 49.6142 32.4858 32.2593 19.8009 3.1546 -7.06015 +7893 6 25.2092 18.0177 27.0119 4.84672 -18.7822 -3.15467 +7894 4 24.5216 17.4674 27.4199 2.41306 12.0417 3.55819 +7895 4 25.6695 17.4202 26.3966 -2.25094 9.61905 1.21472 +7896 6 1.75029 41.5558 24.9373 10.8929 -9.66126 -16.5331 +7897 4 1.94143 40.8029 24.3062 -11.1729 27.8661 22.017 +7898 4 1.33214 0.330238 24.3814 7.15774 -16.2959 10.6574 +7899 6 18.6827 11.7655 10.8523 -12.8723 -21.6642 16.1997 +7900 4 19.5636 11.9042 10.4948 -5.12175 -0.337419 -4.96303 +7901 4 18.6779 10.8452 11.2231 -2.76434 23.9208 -10.2934 +7902 6 45.6216 16.5622 4.85345 35.2391 7.72621 -8.96994 +7903 4 46.5826 16.2921 4.84248 -29.2944 1.01327 2.32041 +7904 4 45.6571 17.5026 4.56372 -8.00263 -16.2723 6.75488 +7905 6 40.6693 36.3938 24.0175 15.8353 8.34465 -33.37 +7906 4 40.8833 36.7626 23.1096 -14.2319 -6.57786 31.0793 +7907 4 40.765 35.4388 23.9669 -2.25062 -4.28397 3.06966 +7908 6 32.2103 36.323 4.961 11.3673 -15.0032 -27.5021 +7909 4 31.6022 36.0041 4.27996 -13.8963 14.3234 5.17466 +7910 4 32.9864 35.7931 4.73143 4.05858 7.46319 17.1387 +7911 6 1.60869 14.6755 10.8061 -10.0389 6.06769 39.8197 +7912 4 2.33356 15.3221 10.9109 -7.21973 -7.23845 -0.707439 +7913 4 1.19104 14.6475 11.7231 10.7485 2.93157 -30.114 +7914 6 35.0001 14.2727 28.079 63.2852 10.3217 34.449 +7915 4 34.8812 14.1453 29.0533 -4.19424 -2.10072 -23.3494 +7916 4 34.1798 14.2655 27.6589 -51.5469 -5.32036 -14.2309 +7917 6 54.7125 6.11605 21.8555 -14.0361 -8.25377 2.86163 +7918 4 53.7845 6.02557 22.1597 12.8111 1.82594 -4.22103 +7919 4 0.03027 6.89073 22.319 4.64766 10.0402 5.34703 +7920 6 31.7713 16.925 27.3783 -6.86907 -7.88471 17.2493 +7921 4 30.8352 17.1376 27.29 -7.38275 1.84485 -8.02972 +7922 4 32.1916 17.1776 26.567 8.49209 11.7792 -21.4891 +7923 6 14.465 28.0197 11.093 -4.59026 -39.5121 13.6529 +7924 4 14.1257 28.8224 11.4501 -8.46011 24.0779 0.0563038 +7925 4 14.7692 28.1802 10.1981 4.52198 5.50754 -5.24146 +7926 6 35.6475 19.4845 18.3155 9.57103 -1.809 -3.39748 +7927 4 36.1727 19.3545 19.1113 -4.74674 6.51425 2.74698 +7928 4 35.0476 18.7267 18.3208 -0.78661 10.9943 -3.1182 +7929 6 0.909574 12.7326 15.4512 -4.00403 -44.3255 -0.361194 +7930 4 0.713888 11.7498 15.2844 2.79491 38.2978 9.54583 +7931 4 1.42535 12.7402 16.2831 -6.10996 -1.10113 -5.97882 +7932 6 52.7151 14.8297 20.9852 -8.18072 -78.4028 12.8764 +7933 4 52.2089 13.9625 20.7908 19.9141 35.1606 18.4317 +7934 4 52.3599 15.4219 20.3591 -8.09633 28.1752 -16.3986 +7935 6 7.5074 6.79303 13.6094 20.1749 -33.1825 -2.20484 +7936 4 7.51894 7.72815 13.8132 13.5555 7.5777 -3.02343 +7937 4 8.44355 6.42469 13.5879 -32.5694 21.0012 0.325521 +7938 6 12.8707 29.146 30.9458 -23.5578 15.3335 -40.981 +7939 4 12.9428 28.445 30.3111 -4.06483 -0.044806 -18.3112 +7940 4 13.2276 28.7127 31.6654 25.7046 -17.9249 62.7325 +7941 6 8.91318 29.991 35.6703 -0.0610651 3.14803 31.5119 +7942 4 8.887 30.0597 36.6571 13.1627 -14.4278 -23.4692 +7943 4 8.81345 30.9051 35.4106 0.983205 7.41015 -17.1111 +7944 6 29.2436 7.20633 5.57892 -54.0378 33.243 -15.4453 +7945 4 29.9077 6.6209 5.82325 37.3203 -38.0996 12.3519 +7946 4 28.4255 6.92245 6.05186 24.5111 10.6259 -6.90283 +7947 6 25.8948 9.2579 3.86177 -16.7921 -19.1399 -16.9328 +7948 4 26.6486 8.78935 3.46547 3.6066 2.83982 9.7025 +7949 4 25.146 8.75694 3.47524 9.6908 8.1243 10.3781 +7950 6 46.1591 19.5353 23.8511 81.1089 -3.44953 5.31324 +7951 4 47.0572 19.4192 24.3423 -46.5837 0.334518 -9.80273 +7952 4 46.5432 19.8542 23.0066 -21.4105 0.836057 1.37554 +7953 6 18.5926 35.3225 28.784 52.2521 -24.0621 1.05868 +7954 4 18.6271 36.1437 28.292 -9.91963 10.3291 -8.20284 +7955 4 19.5499 34.9756 28.7398 -42.866 14.0686 4.10052 +7956 6 27.9863 22.6413 32.202 21.6529 -11.7193 -18.2399 +7957 4 28.0891 22.9783 31.3009 1.03266 3.02954 6.56078 +7958 4 27.1414 22.9613 32.5068 -4.28354 -0.549074 4.96673 +7959 6 25.9903 18.4326 22.6797 -22.9747 -15.6034 11.3844 +7960 4 26.7869 18.8273 22.3692 24.9379 13.7229 -5.91644 +7961 4 25.7208 18.921 23.4832 11.724 -6.94511 -8.75168 +7962 6 31.1697 23.092 29.1693 -11.9745 -15.1316 21.2053 +7963 4 31.2077 22.141 28.9533 -3.34012 7.58841 -3.35467 +7964 4 31.7416 23.575 28.5808 9.8436 3.86516 -11.5721 +7965 6 36.6303 4.93142 0.48008 48.3 12.3871 -22.3067 +7966 4 36.6637 5.82298 0.895967 -3.77214 -15.5899 -6.86281 +7967 4 37.4556 4.91994 41.7793 -42.6939 0.501904 23.801 +7968 6 36.4828 20.995 10.0445 1.4409 16.9025 7.88029 +7969 4 36.442 20.1354 9.60774 -3.67605 2.90774 1.0232 +7970 4 35.8889 20.9899 10.8082 0.675338 -5.55749 -3.21659 +7971 6 50.6068 25.1826 18.3885 -34.0155 8.99756 4.28297 +7972 4 49.9165 24.7513 17.8483 3.12051 4.84127 10.9758 +7973 4 51.4426 24.9479 18.0312 23.0155 -7.64449 -5.94589 +7974 6 50.1857 39.6546 12.4249 -35.8487 -4.75972 18.1961 +7975 4 49.7435 38.8097 12.6589 9.38526 12.3917 -5.89531 +7976 4 51.0761 39.4561 12.2056 25.3285 -5.23538 -8.69122 +7977 6 30.5392 12.4112 4.81308 -24.6918 -8.37115 23.8709 +7978 4 30.0105 11.5821 4.90198 12.5687 16.0288 7.14 +7979 4 30.9611 12.2897 3.99028 20.9425 -4.88336 -30.4106 +7980 6 28.9507 15.4785 21.8764 2.88494 -37.77 16.9414 +7981 4 29.2026 14.5932 22.3105 -13.0637 39.016 -13.1967 +7982 4 28.2142 15.8194 22.4189 7.40001 -5.36107 -10.8423 +7983 6 14.0621 9.56364 16.9937 6.86557 -12.9325 3.68967 +7984 4 14.7638 8.91135 17.1437 -0.397896 3.39204 -3.97785 +7985 4 14.5001 10.412 17.0773 -1.84745 7.98018 -3.95086 +7986 6 4.48418 30.1793 11.8502 16.4679 -16.8356 33.0547 +7987 4 4.88144 29.8061 12.6848 -7.18701 8.62616 -23.9784 +7988 4 3.54784 30.2411 12.0492 -7.30801 4.11375 -9.31782 +7989 6 40.8925 8.06286 23.6531 -5.33465 -0.617655 -7.49645 +7990 4 40.8929 8.28602 22.6923 5.67883 -10.477 13.1878 +7991 4 40.7177 7.10184 23.7416 4.86142 9.55736 -10.8624 +7992 6 53.7474 35.0502 16.7091 9.64852 13.8526 -34.5004 +7993 4 53.4511 35.8404 17.1588 -1.68768 2.98716 11.3576 +7994 4 54.0332 35.3898 15.821 -5.01984 -16.258 24.672 +7995 6 53.7089 10.1864 20.3635 2.29909 -3.91508 11.8946 +7996 4 53.865 9.95358 19.435 -6.30341 10.2468 0.803923 +7997 4 53.074 10.9174 20.4153 4.1525 1.61451 -13.3956 +7998 6 4.58325 27.0727 7.79253 38.2121 26.3993 -10.0836 +7999 4 5.27724 26.393 7.80253 -10.2172 -9.80276 1.23658 +8000 4 3.71677 26.7514 7.92113 -24.69 -25.9094 6.50141 +8001 6 50.5074 22.5408 22.1421 -8.69376 -16.3879 19.9073 +8002 4 50.2488 23.2402 22.7623 5.11604 2.17524 -13.9015 +8003 4 50.7961 22.8564 21.2903 3.5618 14.8025 -7.32432 +8004 6 7.04732 27.2027 21.6256 -40.8926 -21.8944 23.9514 +8005 4 6.7035 26.7027 22.422 28.3929 12.8045 -18.4773 +8006 4 6.19014 27.4064 21.2095 22.0893 5.82121 -6.88916 +8007 6 23.8331 35.0488 16.5891 16.32 14.4309 46.4508 +8008 4 24.6955 34.7392 16.9507 -15.4311 10.68 -10.0146 +8009 4 23.6772 34.608 15.7848 -0.180345 -20.5093 -35.2233 +8010 6 5.99568 23.9111 3.91414 -16.1284 -13.3557 2.33299 +8011 4 5.47632 24.0272 3.08057 3.14343 -7.41418 20.837 +8012 4 5.41258 23.5631 4.6401 5.53308 9.77645 -18.8553 +8013 6 38.7285 25.0725 19.1284 6.5843 12.292 11.4002 +8014 4 38.8305 24.3279 18.5317 -0.433768 -14.0645 -4.65001 +8015 4 38.9527 24.8378 20.0476 4.74577 -1.1864 -10.184 +8016 6 12.9754 18.2903 10.6176 0.588158 -4.74371 -11.7219 +8017 4 12.1189 18.2831 10.1754 -4.50324 1.27903 -1.36841 +8018 4 12.8026 18.5801 11.5112 2.24696 5.46905 14.7352 +8019 6 38.0467 41.2366 21.1082 -14.4892 -16.6352 -5.66336 +8020 4 37.1721 40.8226 21.1941 10.2151 -2.13153 3.70269 +8021 4 37.8745 0.133442 20.6393 0.730193 23.6843 -6.95691 +8022 6 6.9767 22.8602 17.8447 -15.6268 -18.8158 0.81989 +8023 4 7.5707 23.5707 17.6602 21.732 18.7089 -7.75629 +8024 4 7.31556 22.0497 17.428 2.05587 4.83625 4.35773 +8025 6 24.1095 19.3932 12.3316 12.1602 -2.11517 -13.1018 +8026 4 23.8745 19.734 13.1953 2.64822 12.0925 0.881714 +8027 4 23.8476 18.4865 12.3899 -10.6841 -23.2361 -5.46211 +8028 6 44.2232 28.4408 4.82746 -1.7669 2.66578 -25.5607 +8029 4 44.2803 28.1144 3.91045 1.22274 -3.80694 10.7546 +8030 4 44.1446 29.3994 4.68927 4.81937 -0.158515 8.55 +8031 6 23.3113 8.29915 21.4219 -9.51684 27.1403 7.66167 +8032 4 22.936 9.22921 21.4746 15.7805 -27.4461 5.90598 +8033 4 23.1012 8.0569 20.5135 3.89809 -6.65443 -0.402871 +8034 6 14.3464 2.18773 18.5362 -23.516 16.4481 4.67993 +8035 4 14.2678 1.24418 18.6898 10.1474 -10.2606 4.48578 +8036 4 15.2445 2.40605 18.3047 18.9771 -8.71598 -6.68368 +8037 6 28.0424 31.9381 34.1184 1.44373 -10.4149 10.0158 +8038 4 28.467 32.321 34.8914 3.92062 5.65333 3.09761 +8039 4 27.2701 32.5111 33.9835 5.51879 -6.95928 -12.9635 +8040 6 53.345 24.6925 18.2818 -10.4918 -25.9433 -31.7967 +8041 4 53.4866 24.6975 17.3285 -0.882305 -10.6531 -2.1422 +8042 4 53.7306 25.5021 18.5264 15.118 39.739 24.3772 +8043 6 36.8049 28.4285 22.9464 16.1639 5.31016 -1.79263 +8044 4 36.683 28.9472 23.7552 -13.3671 -7.69746 -0.238436 +8045 4 36.1639 27.7179 22.9267 -11.0056 -9.60672 10.1241 +8046 6 21.894 30.586 27.4834 -30.837 -7.47848 12.2714 +8047 4 22.1658 31.0121 28.3029 9.93408 7.2142 -4.82479 +8048 4 22.5499 30.6966 26.8178 23.3081 1.01511 -13.2982 +8049 6 10.2866 3.2829 27.2371 9.19947 -3.548 -7.92128 +8050 4 10.1566 2.73648 28.0281 -11.5907 7.20828 -5.58516 +8051 4 9.50383 3.79492 26.9844 -8.05462 -4.00143 11.7964 +8052 6 37.7145 25.01 29.7057 15.6828 -51.4836 -24.4954 +8053 4 38.34 24.5625 29.0621 -16.831 21.3675 19.2093 +8054 4 37.2613 24.2159 30.07 -2.41186 22.6264 5.87672 +8055 6 9.13271 24.4444 14.4751 26.0421 8.18538 46.692 +8056 4 9.10912 24.9781 13.7161 -5.31341 21.9098 -32.4591 +8057 4 8.68548 23.6494 14.2981 -19.3974 -37.2941 -14.6224 +8058 6 52.771 31.4727 7.38558 20.6973 -2.13415 1.08713 +8059 4 52.3061 32.183 6.93204 -2.34942 2.78723 -4.55897 +8060 4 52.1263 30.9997 7.89938 -16.8139 -9.70652 3.3966 +8061 6 21.3286 5.45224 36.4983 22.333 -40.4406 3.83692 +8062 4 20.7026 5.40277 37.2139 -7.55906 11.9598 8.05023 +8063 4 21.8475 4.61683 36.6516 -9.65069 29.8227 -15.0031 +8064 6 25.1743 37.2092 4.31919 7.23092 6.80805 -6.24923 +8065 4 25.4754 36.7175 3.5165 -8.68629 0.834167 19.7743 +8066 4 24.8491 36.6197 5.01948 2.53349 -5.19005 -7.77823 +8067 6 34.0165 17.4759 18.2358 -58.4306 -31.0723 45.6386 +8068 4 34.1944 16.9598 19.0779 8.50138 15.1756 -22.5601 +8069 4 33.0528 17.7413 18.4058 39.5305 3.9888 -12.396 +8070 6 37.9578 37.5059 25.2944 -35.6234 -15.4362 -10.7836 +8071 4 36.9622 37.6721 25.197 38.0574 -5.35834 -1.14338 +8072 4 38.1643 36.7565 24.689 -7.79603 13.8086 8.25116 +8073 6 5.07735 4.86484 15.8417 42.9381 3.72816 7.10952 +8074 4 5.88838 4.293 15.9163 -33.8081 0.492332 -6.16483 +8075 4 5.50277 5.71956 15.9997 -16.006 -0.473971 1.61617 +8076 6 14.1507 7.19336 7.76886 38.052 -10.4208 -22.4486 +8077 4 13.5129 7.55624 8.34295 -29.9694 15.266 25.1048 +8078 4 13.7195 6.96448 6.9333 -0.98027 3.69224 9.82406 +8079 6 24.98 10.8641 38.0829 22.9212 14.7137 56.6455 +8080 4 25.3157 11.7906 38.09 -5.76353 -21.6486 -14.5596 +8081 4 24.5861 10.6473 37.2742 -21.4949 -6.61803 -48.2716 +8082 6 35.683 7.97762 22.8121 -8.7657 -2.24292 -6.28447 +8083 4 36.2591 8.71308 23.0369 7.49089 3.45465 4.10549 +8084 4 35.4159 8.13228 21.894 -1.16553 2.61323 2.89561 +8085 6 24.8067 29.1485 22.4175 -2.13284 -11.1741 5.39142 +8086 4 24.8847 28.3567 22.9764 5.78872 7.02228 0.265808 +8087 4 23.868 29.1687 22.2304 -8.38579 3.51829 -7.32943 +8088 6 38.496 31.6463 38.4547 5.18571 -7.52333 -11.192 +8089 4 38.5561 32.3892 37.8222 0.442926 -5.96945 11.3455 +8090 4 38.4779 31.9675 39.3579 -6.04594 15.0172 8.52038 +8091 6 7.23911 33.2316 15.4021 21.919 9.41665 12.382 +8092 4 8.12833 33.2899 15.8377 -30.0201 5.59214 -9.80336 +8093 4 7.41373 32.5516 14.7298 -12.8129 5.82399 11.4308 +8094 6 43.353 23.6104 1.44592 7.44142 11.305 12.851 +8095 4 43.1845 24.4377 0.974361 -3.6145 -11.1369 -5.61195 +8096 4 44.1543 23.8467 1.95013 -11.1925 -12.9992 -13.6036 +8097 6 3.53991 32.9016 14.8697 -2.39625 2.76445 6.29056 +8098 4 3.69073 33.2429 13.9877 -3.53656 0.018747 -12.9915 +8099 4 3.78624 33.6349 15.4383 2.83762 5.11564 5.16825 +8100 6 25.3096 21.77 8.26163 -6.66296 0.990367 -4.9072 +8101 4 26.025 21.1206 8.24337 -4.14835 5.1806 10.2199 +8102 4 24.7855 21.68 9.08833 13.2195 -2.77387 -11.0894 +8103 6 43.8224 15.3683 17.7688 -17.5044 -13.9077 -11.4765 +8104 4 43.5422 15.0425 16.8907 -4.65964 7.2866 4.53357 +8105 4 44.7684 15.2434 17.7192 12.2011 1.97977 1.51727 +8106 6 15.7838 16.2525 16.6573 54.0838 12.7989 52.3812 +8107 4 16.4697 16.8261 16.2793 -6.54184 -0.771336 -3.5329 +8108 4 15.1467 16.1661 16.0105 -48.6612 -2.23154 -48.9531 +8109 6 31.9022 12.8519 11.5241 2.75902 49.2592 5.12049 +8110 4 32.4395 13.2725 12.2474 -7.6131 -20.2803 -12.0836 +8111 4 31.5562 13.6461 11.0457 0.0384164 -26.7823 6.27126 +8112 6 18.2248 5.33623 10.1812 -15.488 18.8418 -23.6702 +8113 4 17.7687 5.75894 9.42369 15.7694 -11.8332 4.62439 +8114 4 17.5271 5.29555 10.8288 -1.36455 -9.23689 12.3446 +8115 6 23.0917 39.0779 10.9282 -11.4905 7.21092 -0.352408 +8116 4 23.963 38.6888 10.8472 1.7552 7.95734 1.65941 +8117 4 23.1114 39.9529 10.5005 0.666922 -10.0515 1.633 +8118 6 46.8677 33.7562 8.76248 1.03354 -2.05441 8.38343 +8119 4 46.5037 34.5328 8.27588 2.5022 -8.853 20.9954 +8120 4 47.1475 33.9422 9.6931 -6.44786 13.1686 -22.3696 +8121 6 31.243 39.9317 20.2224 2.33635 -7.70313 -8.05101 +8122 4 30.8704 39.2996 19.5871 0.699046 7.37293 6.91414 +8123 4 32.2017 39.8574 20.0757 -3.27099 6.09826 0.0696837 +8124 6 15.889 33.0919 19.7864 33.8788 -7.40125 -13.3883 +8125 4 16.1628 33.8221 19.1895 -10.4151 -15.5823 0.760964 +8126 4 16.5176 32.3427 19.5839 -16.9866 18.4919 10.6578 +8127 6 32.5555 39.9164 2.66523 30.0039 -10.6491 -2.95451 +8128 4 33.3508 39.5896 3.12591 -10.8726 3.49711 -8.16538 +8129 4 32.1027 40.3655 3.36837 -16.5932 8.39248 6.84073 +8130 6 50.6959 12.1983 3.90519 17.0412 -18.9771 -24.2847 +8131 4 51.4658 12.4814 3.40053 -2.43524 -2.94964 -4.56419 +8132 4 50.632 12.8314 4.58319 -9.04718 30.5099 32.8795 +8133 6 44.7022 2.76366 12.1205 -8.84849 12.6495 8.41904 +8134 4 44.8494 1.8734 11.8267 15.0216 -15.1797 -4.64519 +8135 4 44.7278 2.73137 13.1008 3.87902 2.35132 -20.2006 +8136 6 11.5141 11.9335 31.6448 -3.41939 3.48047 19.9552 +8137 4 11.2577 12.7405 32.1375 2.53248 -5.05318 0.0588515 +8138 4 11.4496 11.2091 32.2982 6.40928 8.91696 -7.15415 +8139 6 4.75269 10.0418 10.4949 -1.19321 15.9867 3.21309 +8140 4 5.0001 10.2283 11.4058 3.15466 -0.54389 -0.234941 +8141 4 4.46559 10.9018 10.1184 3.18705 -14.0527 1.96128 +8142 6 17.0994 25.0099 20.58 37.5195 36.994 -31.4742 +8143 4 16.2483 24.8536 20.9144 -42.3557 -15.7488 8.6923 +8144 4 16.9647 25.6792 19.8535 4.26961 -24.361 15.5384 +8145 6 48.1092 4.75471 14.8037 19.9531 12.9172 -19.4869 +8146 4 47.21 5.0173 14.8371 -33.3483 -4.43172 15.4156 +8147 4 48.388 5.38041 14.11 12.4129 -13.382 8.75366 +8148 6 18.8523 3.11742 3.41631 -21.2483 -3.07087 -4.7476 +8149 4 18.4665 2.24821 3.59937 1.50537 0.955968 2.27262 +8150 4 19.7704 2.98892 3.60058 26.8928 -3.50499 2.30699 +8151 6 35.4247 26.4577 29.0527 -22.8013 -8.66021 5.68805 +8152 4 35.5248 27.2067 28.475 -2.85698 13.778 -9.76065 +8153 4 36.2768 26.0489 29.0602 21.3259 -10.4415 3.203 +8154 6 32.3896 31.2185 12.8503 57.1958 12.7231 -6.23232 +8155 4 31.5925 31.2509 13.3022 -48.7441 2.01486 27.8379 +8156 4 32.2029 30.8426 12.0127 -5.8383 -14.614 -31.3947 +8157 6 33.0076 28.3366 37.5983 -27.3824 -5.67666 30.0102 +8158 4 32.1052 27.9852 37.8568 28.4022 2.55731 -9.07316 +8159 4 33.3988 28.5694 38.4733 -3.969 -4.9759 -22.0899 +8160 6 45.5072 24.7908 10.3169 -45.8214 60.3209 -7.47747 +8161 4 44.9002 25.317 9.70444 28.5781 -13.9385 29.3176 +8162 4 45.5876 23.9971 9.85482 14.9117 -49.3191 -19.3714 +8163 6 14.779 31.7044 3.16918 -45.5594 -6.97168 29.5477 +8164 4 14.0337 32.2859 2.90387 21.9125 -3.3602 -3.07131 +8165 4 14.4311 31.26 3.996 20.2164 14.1486 -26.6391 +8166 6 31.9242 7.68885 4.30286 23.54 -20.9123 31.4536 +8167 4 31.4705 6.84633 4.17995 2.0164 -2.82895 4.59018 +8168 4 31.5931 8.24323 3.64247 -18.259 33.7262 -37.7068 +8169 6 42.5699 17.3136 32.1968 24.1944 7.3606 3.32713 +8170 4 41.6254 17.2329 32.2603 -19.9776 4.79877 -7.53323 +8171 4 42.7917 18.2007 31.8224 -10.4585 -19.5065 0.0265862 +8172 6 13.8071 23.1746 23.5515 16.4347 -15.6283 -2.15259 +8173 4 13.5183 23.7639 24.245 0.233797 9.11225 10.6616 +8174 4 14.6093 22.7029 23.9066 -20.7684 16.5326 -5.05411 +8175 6 10.7126 7.09833 3.97095 14.1471 -33.6721 -68.9477 +8176 4 10.4245 6.93934 4.82914 -14.4566 -0.97954 55.1879 +8177 4 10.4869 6.2311 3.50145 10.3151 35.4271 10.8748 +8178 6 28.7967 8.6797 17.9015 -30.1103 -2.72244 -33.0478 +8179 4 29.5795 8.35746 17.4579 9.90558 -6.78874 -8.85398 +8180 4 28.1705 8.90161 17.1378 19.1156 -3.64084 26.8114 +8181 6 19.4515 29.3423 26.6295 -39.4767 12.5835 42.7579 +8182 4 19.0038 29.6555 27.482 17.5864 -10.0531 -35.2193 +8183 4 20.2946 29.7741 26.6551 17.8114 4.03003 1.9258 +8184 6 40.6571 40.9865 14.5722 30.7749 0.116883 17.4953 +8185 4 40.9453 41.7159 14.038 -4.90719 13.3855 -18.4876 +8186 4 41.4974 40.7167 14.9881 -11.2006 -4.47055 2.16552 +8187 6 46.2595 14.0857 31.7293 11.6035 -9.35965 4.24636 +8188 4 46.4659 13.1386 31.6985 -1.25294 5.8657 1.71226 +8189 4 45.5092 14.1916 31.1613 -13.5258 4.10617 -10.238 +8190 6 36.7111 36.3198 8.38634 20.5175 24.5507 44.7988 +8191 4 36.5848 37.248 8.66174 -25.6048 -20.3538 -28.8485 +8192 4 37.4262 36.1922 9.03978 -4.76011 -28.7723 -18.9481 +8193 6 30.7791 32.4382 38.0814 8.60258 1.74334 21.9396 +8194 4 31.3949 31.9394 37.5795 9.21482 -20.9838 -26.5205 +8195 4 31.4122 32.9586 38.5821 -11.3785 16.1645 3.6603 +8196 6 47.8794 8.8384 10.1746 26.299 41.1069 27.7005 +8197 4 47.2075 9.11907 9.56312 -13.0744 -2.84885 -16.672 +8198 4 48.1152 7.93695 10.1106 -1.40956 -33.8723 -12.987 +8199 6 24.4191 17.0005 30.9872 -11.3759 2.04439 -13.9008 +8200 4 23.6647 16.9339 30.3566 16.9629 0.0568796 9.7226 +8201 4 24.0218 17.1528 31.8579 2.94571 -1.21426 -7.57694 +8202 6 40.5018 5.09847 4.47991 -26.6992 -20.3188 -5.14046 +8203 4 41.28 5.65048 4.47318 14.3705 11.228 -11.5737 +8204 4 40.0798 5.05838 3.58104 19.0568 4.03597 15.916 +8205 6 52.5742 28.0973 6.9077 -25.4379 -29.0344 16.6943 +8206 4 52.3933 28.6001 6.11132 1.2128 1.19853 -1.81518 +8207 4 51.7383 27.5823 7.10916 28.4347 22.908 -9.38917 +8208 6 36.064 32.3866 23.6124 7.53581 -25.1682 -6.10704 +8209 4 36.4508 32.2046 22.7426 1.48893 5.77393 9.47334 +8210 4 35.7934 33.2936 23.5958 -9.41601 17.7382 0.925908 +8211 6 23.6488 31.8764 22.7665 2.85736 4.06253 -9.33391 +8212 4 23.7634 32.5358 22.0878 -9.04528 15.3932 -0.43099 +8213 4 24.3599 31.3007 22.5126 8.23075 -21.5035 13.0322 +8214 6 0.735457 24.4657 41.7131 -9.37188 -1.3071 -20.2528 +8215 4 1.20497 24.8068 40.9273 -3.735 -3.01915 11.177 +8216 4 54.8235 24.2347 41.4089 15.688 5.53844 3.35783 +8217 6 15.9771 8.98022 19.8191 22.6241 -28.8974 20.594 +8218 4 15.5109 8.26292 19.4118 -7.13343 -10.7615 -13.7959 +8219 4 15.6388 9.77471 19.4696 -19.2292 39.8019 -15.8774 +8220 6 33.1716 12.5629 20.0326 13.9441 -12.6476 -4.49459 +8221 4 32.9044 11.6183 19.8429 16.5289 30.3248 6.35834 +8222 4 34.162 12.7185 19.975 -34.5589 -12.2038 -12.3621 +8223 6 7.03971 24.945 26.3683 -0.33354 -9.69316 23.9049 +8224 4 6.80945 24.3756 27.1101 -9.22275 -9.46444 -2.85995 +8225 4 7.84656 25.3251 26.6963 17.391 9.90995 -3.06061 +8226 6 44.4739 22.5508 36.9255 -16.7075 -6.88118 10.4755 +8227 4 43.5027 22.4108 36.9334 15.1456 1.07948 9.67769 +8228 4 44.6732 22.7799 36.0336 3.04889 5.98288 -21.3947 +8229 6 39.2775 23.7142 25.1185 -44.4168 -97.0378 5.9092 +8230 4 39.6033 24.5307 24.937 33.9242 88.3913 -14.6991 +8231 4 38.7559 23.4597 24.3323 8.03463 3.9453 13.1815 +8232 6 20.3756 2.20712 36.9897 -7.56257 -5.27652 1.95266 +8233 4 20.2168 1.45659 37.5665 4.06747 -3.41627 8.94019 +8234 4 20.2802 1.85339 36.1124 5.28277 1.38 -10.8685 +8235 6 22.8571 19.5527 3.6659 6.2145 7.79245 45.4341 +8236 4 22.8782 19.7834 4.64919 -10.5004 -5.13291 -37.3231 +8237 4 23.7426 19.8021 3.38476 9.02488 -3.84737 -6.15569 +8238 6 31.6989 12.5719 34.5929 20.3571 12.3337 69.8717 +8239 4 31.0774 13.2339 35.0297 17.9304 -15.3013 -22.977 +8240 4 32.3378 12.3324 35.3667 -30.4994 7.85147 -45.3393 +8241 6 12.9846 10.2214 25.1019 -30.6317 10.0697 -32.3453 +8242 4 13.6677 9.95937 25.6652 38.8731 -4.05338 37.0168 +8243 4 12.5116 9.4018 25.0264 -11.673 -9.01961 -8.06086 +8244 6 27.2702 0.587979 13.2088 -29.2359 -8.68669 8.17042 +8245 4 27.7024 41.6312 13.2942 -2.56798 3.03598 -7.56301 +8246 4 26.2795 0.464606 13.259 26.6373 -0.778522 -5.81594 +8247 6 5.6575 24.9337 13.9905 13.1991 2.90197 -9.87868 +8248 4 4.70598 24.9553 13.883 -5.9976 0.782062 8.57209 +8249 4 5.90972 25.4072 14.7914 -9.20077 -1.59682 1.38283 +8250 6 22.9799 17.9518 0.527007 -12.0607 -30.0717 13.8125 +8251 4 22.428 18.6392 0.176667 -3.67819 14.6501 -9.17369 +8252 4 22.2816 17.3415 0.914453 31.709 16.1034 -10.9012 +8253 6 33.0985 25.4181 5.46205 -15.7978 -31.0624 1.20161 +8254 4 33.3789 26.3039 5.55078 15.9502 30.9866 -6.27287 +8255 4 32.9645 25.2082 4.52957 3.04969 3.7853 3.27689 +8256 6 8.52872 7.94688 17.4833 18.4257 15.9711 -24.7978 +8257 4 9.39098 8.3855 17.3119 -11.8135 -8.35054 -2.98105 +8258 4 8.4858 7.94817 18.4262 -6.55829 -2.0729 23.5191 +8259 6 26.8237 0.686378 2.88748 4.07 30.2002 2.01549 +8260 4 26.8412 0.391628 3.80568 -3.86709 0.733005 8.35451 +8261 4 26.5975 1.66265 2.91719 8.86873 -29.5911 -1.41132 +8262 6 50.0397 34.7157 15.6267 -11.8175 -1.09292 -1.87233 +8263 4 50.6372 35.2521 15.0721 -14.1207 -5.91477 -4.02646 +8264 4 49.1323 34.6374 15.219 24.748 6.82197 2.94942 +8265 6 46.275 5.00035 11.1282 9.7079 18.7279 -10.06 +8266 4 45.8191 4.20733 11.3912 -11.1099 -14.8598 8.88229 +8267 4 46.9633 4.71614 10.5231 1.70636 -6.51939 -1.67277 +8268 6 33.7833 38.63 35.3851 22.6491 -26.5736 53.3982 +8269 4 34.0604 38.9625 36.3013 -14.2885 -2.00103 -44.5517 +8270 4 33.6201 39.3455 34.786 -2.63152 22.0909 -4.2817 +8271 6 30.8201 25.8435 41.2101 0.522631 -30.718 -12.9218 +8272 4 31.0968 24.9266 41.4082 -1.05643 6.85883 -6.1679 +8273 4 31.1715 26.3436 0.016995 6.66556 20.3816 22.2796 +8274 6 50.2276 0.978128 24.4598 74.6558 22.0158 36.8282 +8275 4 49.5306 0.534407 24.0585 -38.5843 -30.8873 -31.929 +8276 4 51.1134 0.532188 24.3239 -37.6779 9.32343 -0.630533 +8277 6 31.2996 0.720873 19.0302 14.3507 40.5737 -10.6901 +8278 4 30.4605 0.743437 18.5837 -16.9464 -9.10756 -3.3833 +8279 4 31.3343 41.8987 19.5933 -6.31648 -47.867 22.0648 +8280 6 39.0778 29.5479 19.1423 -24.9794 -6.4558 -1.7207 +8281 4 38.1293 29.5816 19.4551 33.1986 -8.08964 -3.40762 +8282 4 39.446 28.6506 19.2986 -6.02354 14.8003 0.990496 +8283 6 21.659 17.5991 25.8953 -11.5386 33.2832 -7.33353 +8284 4 22.0418 18.5204 25.967 -8.02723 -30.5851 6.12101 +8285 4 20.778 17.7492 25.4824 18.7799 -9.30112 4.66445 +8286 6 35.0777 28.803 27.4254 -1.70316 -21.0069 37.4458 +8287 4 35.3301 29.4791 28.0775 3.3924 -2.39002 -8.5847 +8288 4 35.0935 29.2141 26.5843 6.79083 21.8236 -32.9604 +8289 6 30.7137 25.4449 11.6588 -11.4017 25.922 39.321 +8290 4 30.5753 25.9017 12.5616 8.60864 -26.5127 -36.0552 +8291 4 30.5331 26.1452 11.022 4.69716 -0.666916 0.479504 +8292 6 7.33812 15.1344 12.3538 4.68116 -40.544 31.6975 +8293 4 6.75693 14.3594 12.209 2.06777 16.361 -3.14284 +8294 4 7.31295 15.622 11.5607 -9.0052 27.071 -31.8075 +8295 6 16.8334 26.8188 7.04972 -25.5936 3.66279 -30.8653 +8296 4 17.5758 26.708 7.59816 38.4339 -11.2263 23.8467 +8297 4 17.1819 26.9966 6.1597 -5.58153 -2.73835 6.66814 +8298 6 29.5302 33.0784 31.0001 -37.3865 -15.0005 -19.6245 +8299 4 28.6433 32.7554 30.7459 2.04647 15.9344 -4.27919 +8300 4 29.8764 32.2746 31.3613 18.5632 -10.7791 20.7082 +8301 6 14.1048 2.11879 30.9099 -3.69766 -14.7615 43.6071 +8302 4 14.1458 1.95878 31.9138 -8.46722 9.63961 -39.7078 +8303 4 13.6642 1.31591 30.5661 9.09938 8.95306 -0.112961 +8304 6 15.6571 22.2632 2.89617 -37.5764 43.5932 -9.62192 +8305 4 16.4348 21.7941 3.05118 39.5293 -34.0009 4.7875 +8306 4 15.0286 21.6897 2.4522 -3.10464 -12.538 6.06705 +8307 6 23.7259 29.1153 40.9645 17.3396 38.8389 1.6287 +8308 4 23.2818 30.0193 40.9831 11.4767 -32.1544 -0.906545 +8309 4 24.7087 29.2887 40.9216 -25.4222 -7.32646 2.20707 +8310 6 38.1247 14.1642 13.7107 12.8592 31.0763 6.54808 +8311 4 37.6278 13.3808 13.8383 -17.8092 -31.0521 2.1891 +8312 4 38.9029 13.9224 13.2095 7.41852 -3.42228 -8.90759 +8313 6 35.2503 26.5068 15.521 -3.09354 13.3371 19.8917 +8314 4 34.5349 26.5126 14.8818 -0.932758 -4.81772 -4.34805 +8315 4 34.9075 27.0382 16.2823 10.0491 -13.0104 -19.4153 +8316 6 19.0968 34.7379 16.486 5.71756 23.995 22.7437 +8317 4 19.4075 35.6523 16.3704 4.72819 -11.1284 17.3551 +8318 4 19.0401 34.4508 15.6072 -6.41662 -20.6903 -39.0731 +8319 6 18.1723 29.7514 35.7083 20.6671 12.6318 -10.71 +8320 4 18.3041 30.5743 35.1773 -7.60682 -14.8418 20.474 +8321 4 19.0351 29.5718 36.145 -10.3356 2.9076 -6.19235 +8322 6 54.1213 22.2675 24.9131 12.7342 -33.1199 -26.8219 +8323 4 53.6265 21.7967 24.1967 9.15099 10.4438 12.7736 +8324 4 53.5183 22.8995 25.2476 -23.1208 24.5105 7.38222 +8325 6 30.3446 10.3415 34.0026 7.84994 -0.761596 -9.91104 +8326 4 29.5868 10.4349 34.5739 -14.9697 1.07498 11.7851 +8327 4 30.8511 11.1643 34.0933 -4.52293 -3.62201 3.70872 +8328 6 38.3178 33.8965 18.5989 -35.8058 -11.4104 -3.76591 +8329 4 38.923 33.166 18.7063 19.7544 -4.29321 9.06839 +8330 4 38.8137 34.6503 18.3352 23.7539 21.4454 3.52643 +8331 6 22.4873 14.1653 34.4312 -21.9658 -17.0918 -49.1801 +8332 4 22.5571 13.4626 33.7145 -4.81718 29.7264 22.473 +8333 4 23.0772 13.8965 35.1058 26.7449 -1.29975 22.8703 +8334 6 38.021 0.617904 2.36461 -2.26574 -7.91048 -40.4777 +8335 4 37.6239 1.19646 3.0125 3.99393 1.59858 23.4614 +8336 4 38.7851 0.132723 2.71367 -6.22024 4.30596 13.4956 +8337 6 38.885 41.133 10.292 38.4397 69.693 -20.9517 +8338 4 38.7327 0.223589 10.3334 0.502898 -40.1285 -2.38265 +8339 4 38.1678 40.7662 10.7395 -40.074 -22.1176 34.0334 +8340 6 53.417 21.9266 38.962 18.4876 1.53578 17.2983 +8341 4 52.9974 21.8755 38.1026 3.71535 5.74942 -10.4205 +8342 4 54.37 22.1639 38.7939 -25.8904 -11.793 -3.59034 +8343 6 39.9933 12.7125 36.2959 -18.8272 27.1562 12.2819 +8344 4 39.0734 12.4542 36.2547 -7.90274 -1.75871 9.35878 +8345 4 40.3901 12.0873 35.7283 26.8007 -18.4843 -23.2317 +8346 6 48.44 17.2431 40.5981 -19.9836 6.93831 4.04917 +8347 4 47.6199 17.7956 40.4399 22.5854 -23.5642 7.97707 +8348 4 48.3147 16.8142 41.4747 5.07747 10.2388 -9.33604 +8349 6 32.0284 9.3439 40.0151 10.5149 -12.1651 13.6504 +8350 4 32.8546 9.41316 39.523 -1.99935 -3.17675 -6.39298 +8351 4 31.9706 8.39334 40.2816 -10.0936 21.7982 -4.27543 +8352 6 31.75 22.4929 6.3685 -34.2181 3.54143 23.53 +8353 4 31.3779 21.709 6.82557 12.2201 6.35834 -11.7559 +8354 4 31.3059 23.2194 6.8777 16.0591 -13.7554 -15.3432 +8355 6 51.0144 2.58529 21.579 28.4772 -3.64411 10.4611 +8356 4 51.4343 1.72703 21.8198 -11.0001 9.38403 -4.71992 +8357 4 51.7571 3.20177 21.4507 -11.3685 -6.83795 2.38662 +8358 6 13.6247 22.0465 12.1442 29.0901 0.46256 9.76546 +8359 4 14.4578 22.3795 12.5465 -13.9989 1.27328 -8.95219 +8360 4 12.915 22.6494 12.3833 -3.04453 8.5056 -1.94564 +8361 6 23.6209 24.0381 14.6453 -17.5202 11.834 -36.5316 +8362 4 24.2009 24.4886 15.2598 9.8869 4.60732 -3.70937 +8363 4 23.5497 24.6116 13.8304 3.00595 -20.2815 30.972 +8364 6 9.32136 4.85156 31.2387 8.97842 0.466865 -3.67014 +8365 4 8.41764 4.8259 30.9291 -8.7496 -0.132795 -7.84821 +8366 4 9.23666 5.38964 32.029 2.44443 -3.9247 9.21777 +8367 6 16.6769 26.3146 18.0426 -28.7898 -24.0576 -1.25383 +8368 4 15.7763 26.5978 17.7405 22.2361 3.17889 2.46191 +8369 4 17.2688 27.0532 17.9767 7.52301 23.5471 -7.71583 +8370 6 5.12002 13.5179 11.5454 -28.2867 15.553 -42.5279 +8371 4 4.34318 13.4159 12.0982 -3.89331 -5.54815 13.62 +8372 4 4.69334 13.8537 10.6805 23.3071 -7.58808 40.5266 +8373 6 29.613 23.6535 8.07622 4.06305 -5.39054 -18.0309 +8374 4 29.2087 23.3655 8.89798 -2.48969 6.78204 1.65997 +8375 4 29.356 24.5861 7.97247 8.33853 -10.6544 5.22118 +8376 6 0.809058 7.56442 27.8431 6.90575 4.16885 -14.0934 +8377 4 0.916059 7.33161 28.7668 -1.2645 -7.40385 9.39857 +8378 4 1.47033 8.27499 27.7095 -9.19662 -21.8408 -1.77541 +8379 6 15.4183 9.78145 0.490529 10.0725 -7.13925 0.979932 +8380 4 16.087 9.43012 41.8027 -0.259761 -4.12548 -6.98761 +8381 4 15.4693 9.20893 1.26423 -1.27146 5.63374 6.96511 +8382 6 18.8191 0.059487 34.1187 -25.6574 -0.396319 -31.4644 +8383 4 18.4098 41.5755 33.3103 16.2128 4.97009 18.3796 +8384 4 18.5054 0.975155 34.0945 0.533414 5.37151 1.64989 +8385 6 18.7349 30.7803 29.1665 47.4813 -67.7405 25.7886 +8386 4 19.5534 30.6866 29.7899 -42.3671 12.2249 -32.0712 +8387 4 18.5184 31.6699 29.0545 -8.91834 48.7901 3.3651 +8388 6 48.4474 16.4903 36.136 -4.39653 9.55775 -4.4164 +8389 4 47.5651 16.9082 36.2181 15.0357 -0.381514 0.207393 +8390 4 48.471 16.1274 35.2331 3.08724 1.10756 7.15907 +8391 6 43.7979 0.472205 29.2706 42.555 -4.96452 -15.1149 +8392 4 42.8863 0.267919 29.38 -32.9664 -6.64218 10.9475 +8393 4 44.2792 41.5357 29.3524 -8.26894 11.2804 8.78801 +8394 6 16.7205 13.887 21.3769 2.19577 2.66609 -2.49996 +8395 4 16.2052 14.7022 21.5336 6.85381 -11.1318 0.719729 +8396 4 16.6911 13.4037 22.2072 -6.06459 1.50462 5.19021 +8397 6 17.3883 13.4356 26.2524 27.4966 3.2637 -26.6685 +8398 4 18.1303 13.5822 25.5825 -26.8694 -2.13737 32.6247 +8399 4 17.6394 12.6216 26.7148 -3.51452 -0.718268 0.201186 +8400 6 48.1557 10.2329 23.6958 7.66187 -11.6345 21.9365 +8401 4 48.0869 10.5828 24.5972 -4.20109 -8.3855 -4.21906 +8402 4 47.9242 10.9774 23.1563 3.12678 5.33996 -12.4543 +8403 6 28.2651 17.9126 17.8865 15.704 23.8601 -19.8805 +8404 4 29.0328 18.4581 17.6288 -8.16305 -6.08358 1.86534 +8405 4 28.6272 17.0995 18.2183 0.672722 -20.799 10.0784 +8406 6 54.0866 38.1772 23.6885 15.2416 -7.03948 -9.32302 +8407 4 0.015845 37.9236 23.4759 -13.1891 10.5947 7.1207 +8408 4 53.5403 37.6177 23.1226 -4.14834 -2.69562 5.50015 +8409 6 8.47885 18.3973 11.4073 -18.4373 -13.8141 42.9629 +8410 4 7.63335 18.6519 11.0416 -6.40415 6.02722 -6.48684 +8411 4 9.12927 18.583 10.7796 32.3175 8.52747 -41.6205 +8412 6 45.9451 12.8796 11.0371 -17.0736 -2.86831 -37.3051 +8413 4 46.6905 12.613 10.4807 4.61659 2.073 6.35499 +8414 4 45.2044 12.775 10.3831 8.06265 2.44535 24.075 +8415 6 16.2127 8.79404 14.0297 41.7324 -66.6139 22.361 +8416 4 15.4739 9.28873 13.8367 -45.7772 50.9633 -18.0772 +8417 4 17.0286 9.27652 14.012 9.93977 26.888 -8.08533 +8418 6 42.7214 13.3612 21.3881 16.6788 44.7105 -2.77317 +8419 4 41.8036 13.1589 21.3301 -20.1042 -28.5105 -1.62877 +8420 4 42.6833 14.2978 21.1276 5.52546 -8.26362 1.62797 +8421 6 21.0018 40.4256 16.4674 21.2457 -19.0828 1.73859 +8422 4 20.7372 40.049 17.3276 2.67731 3.65462 -7.46566 +8423 4 21.8606 39.9985 16.1939 -29.0987 10.293 9.55187 +8424 6 45.6337 11.4313 32.9356 51.1157 -40.0447 2.01383 +8425 4 46.3303 10.7696 33.2563 -29.172 28.0234 -20.2541 +8426 4 45.1866 11.676 33.7277 -20.3741 9.53259 21.5498 +8427 6 26.9484 8.87146 24.2965 48.4346 1.85391 18.4292 +8428 4 27.5311 9.68141 24.3337 -29.9021 -15.2605 -8.39328 +8429 4 27.4823 8.26118 24.8676 -16.4416 6.67878 -12.0087 +8430 6 18.977 2.43413 29.3663 0.758316 16.52 -7.40381 +8431 4 18.1944 2.4248 29.9271 -0.767207 -2.12047 7.99903 +8432 4 19.1173 3.36872 29.101 -3.03797 -9.07666 7.57415 +8433 6 8.2454 29.1679 19.723 -8.63488 -12.9151 21.1286 +8434 4 8.14448 28.8871 20.6627 3.14293 7.67545 -21.2948 +8435 4 7.83715 28.464 19.1969 -1.03495 3.62674 2.54809 +8436 6 9.03976 34.3129 18.6533 -7.54593 -6.72093 -3.09965 +8437 4 8.77081 34.2931 19.577 -0.177883 2.97642 -7.59668 +8438 4 9.06659 35.2455 18.4187 6.50563 1.62734 -4.46359 +8439 6 10.1892 11.9266 11.2355 -21.5107 11.0325 -1.739 +8440 4 10.2333 12.874 11.065 17.4692 -2.43612 -1.88546 +8441 4 9.23632 11.7983 11.121 5.09535 -6.80078 4.24402 +8442 6 35.7546 21.6858 36.1669 -23.2352 21.9394 0.834429 +8443 4 35.0265 22.3595 36.1433 18.2091 -18.4066 2.26802 +8444 4 36.3924 22.0173 36.8321 -9.99636 -6.87572 -9.75527 +8445 6 17.0812 12.5048 36.3903 -12.1142 25.6516 12.5185 +8446 4 17.3175 12.8308 37.2812 -0.49448 -9.18651 -10.1264 +8447 4 17.5662 11.7075 36.2155 7.76979 -20.5663 -1.07791 +8448 6 37.1566 13.0227 34.2843 -17.9764 -6.1284 -55.2853 +8449 4 36.5549 12.2662 34.3472 4.68366 1.60167 -17.3784 +8450 4 37.3932 13.1268 35.1567 14.9075 13.7384 64.605 +8451 6 38.9862 29.5501 13.2301 -1.89389 21.6683 -7.70005 +8452 4 38.7944 28.7085 12.8419 -2.19861 -17.9948 -10.7911 +8453 4 38.6501 29.4932 14.1174 1.27468 3.77518 16.782 +8454 6 0.176516 29.3495 29.4845 -12.5141 10.2637 -5.31555 +8455 4 0.737394 28.6151 29.2028 3.82179 3.49987 -8.15609 +8456 4 54.9814 29.9211 28.6995 5.57042 -17.7863 13.6106 +8457 6 15.9458 0.256833 12.7596 -44.0073 4.56069 2.48191 +8458 4 15.316 0.578271 12.0799 19.6091 -0.692249 -3.06606 +8459 4 15.3039 41.7798 13.3939 19.5978 -0.7471 3.56907 +8460 6 3.99127 11.9482 8.78851 -15.4327 -39.7622 32.4444 +8461 4 4.35413 11.6179 7.97869 6.27746 3.41828 -23.4587 +8462 4 3.98972 12.8788 8.75552 1.02746 43.1268 -6.73396 +8463 6 24.041 23.6822 19.9783 33.1595 11.366 0.122861 +8464 4 23.6132 22.8866 19.7159 -20.0299 -17.1205 -2.84168 +8465 4 23.4218 24.2757 20.3917 -9.46777 4.2557 4.80954 +8466 6 4.48057 2.29323 23.9805 -22.9759 10.1361 69.4322 +8467 4 4.73792 2.40802 23.1034 3.49419 10.2026 -52.1527 +8468 4 3.69711 2.85929 24.1902 11.7092 -10.5693 -13.4065 +8469 6 33.0966 27.663 33.8386 -28.073 -12.9468 -7.71443 +8470 4 33.3687 28.5694 33.7309 6.85765 13.8135 -2.76136 +8471 4 33.7449 27.1385 34.2981 13.436 1.78162 12.2729 +8472 6 11.3912 21.7129 6.08719 -17.5666 -2.19741 -2.39462 +8473 4 12.3323 21.6847 6.05692 28.5529 -3.65784 2.285 +8474 4 11.1694 22.1681 5.26899 -4.22105 -2.6604 -2.39966 +8475 6 37.2225 13.5364 23.6261 -18.6729 23.2035 4.88571 +8476 4 37.3138 14.0862 24.4412 -7.0733 -14.7121 -13.3014 +8477 4 37.9734 12.9786 23.5155 30.7338 -8.31921 -1.90296 +8478 6 5.00503 21.0366 33.3647 1.8453 38.5327 -33.3657 +8479 4 4.21257 21.4237 32.9267 15.1329 -13.9269 -2.57683 +8480 4 4.69097 20.5075 34.0602 -12.1996 -25.3348 31.8286 +8481 6 18.1998 37.5792 26.9379 10.6598 2.97497 -14.5277 +8482 4 17.7896 38.4267 27.1371 3.99806 -1.69574 -0.528064 +8483 4 18.8493 37.7746 26.2284 -6.0853 -8.42077 12.5802 +8484 6 19.7447 16.1537 4.6847 3.25094 -1.99961 -5.02271 +8485 4 18.927 15.8729 5.11398 3.02189 5.09699 3.93014 +8486 4 20.4865 15.8366 5.22215 -5.31395 3.35724 3.77112 +8487 6 54.074 32.5125 15.5854 10.3761 -37.3618 -30.9158 +8488 4 54.8842 32.2065 16.0104 -1.29748 4.29224 -6.87141 +8489 4 53.7047 33.0976 16.2003 -18.9781 34.1452 25.1436 +8490 6 31.1314 3.81684 36.7321 -0.834289 -2.49025 -7.10722 +8491 4 31.1103 4.02948 37.6722 -6.54843 -2.60835 4.18586 +8492 4 30.7135 2.95482 36.5673 3.74099 5.55874 7.56308 +8493 6 11.8386 14.3591 5.9475 31.6488 6.08621 47.6135 +8494 4 11.9235 13.4381 5.72501 -3.84758 -8.60837 -9.73648 +8495 4 12.4264 14.4198 6.78937 -30.0453 0.761866 -39.8937 +8496 6 30.4739 33.6971 6.46755 -23.3776 20.1936 16.0158 +8497 4 30.0841 33.0849 7.09297 -6.22519 -2.1618 10.9649 +8498 4 31.0937 33.1726 6.0102 25.8315 -23.5027 -25.5745 +8499 6 12.7945 0.536645 21.6661 -31.9857 18.4102 -14.2222 +8500 4 12.046 0.975194 21.1709 21.6431 -18.6961 6.09473 +8501 4 12.7507 0.998686 22.5059 13.427 -0.157027 11.5383 +8502 6 52.7685 7.22113 26.1957 6.97037 27.5507 21.845 +8503 4 53.4259 7.92282 26.4698 -21.5773 -21.2317 -16.9414 +8504 4 53.0823 6.78628 25.4103 4.46247 -3.68205 -10.7225 +8505 6 39.7279 40.8849 3.7445 22.9677 17.8938 -40.8272 +8506 4 39.3244 40.0392 3.76563 -12.6427 -25.5287 10.0743 +8507 4 39.6614 41.3038 4.58361 -3.65945 6.85452 27.763 +8508 6 20.1085 31.9188 21.9984 -7.05206 -5.67602 7.13377 +8509 4 19.4287 32.0842 22.6964 14.9272 -8.91322 -13.6161 +8510 4 20.3617 32.7769 21.6609 2.64243 15.0084 0.0829653 +8511 6 12.8674 35.0052 4.44359 43.5281 -46.0898 9.1613 +8512 4 12.2643 35.7062 4.40975 -34.4326 42.8527 -2.74399 +8513 4 13.784 35.3443 4.35073 -14.7319 6.47242 -4.65586 +8514 6 24.0589 33.6612 24.8588 9.55704 11.7193 -6.52578 +8515 4 23.7303 32.9012 24.3903 -5.13736 -12.3884 -10.0474 +8516 4 24.8786 33.8838 24.3903 -2.58553 -1.28908 -1.69824 +8517 6 40.1426 40.9082 22.7393 38.5538 -20.8809 37.5387 +8518 4 39.5402 41.0833 22.0513 -32.6743 7.60774 -19.3027 +8519 4 39.6696 40.5795 23.5226 -1.01773 2.4492 -9.99125 +8520 6 15.5532 2.81426 38.4448 -20.0738 34.0709 23.3703 +8521 4 14.8967 3.48174 38.7749 9.17215 -23.4566 -12.8824 +8522 4 16.1607 3.33672 37.9186 19.8661 -0.634992 -1.43825 +8523 6 41.016 9.18565 16.9561 17.4117 -10.7022 -18.9926 +8524 4 41.8597 8.69641 16.8054 -9.41989 12.8418 6.23764 +8525 4 40.6131 8.73354 17.6887 -9.17188 -2.41438 15.2761 +8526 6 43.1923 41.3931 9.58697 -22.3356 -19.1489 -3.62619 +8527 4 42.3612 40.9845 9.24256 14.3618 0.824315 8.65898 +8528 4 43.3433 0.185675 8.9708 1.58778 19.1204 -6.9238 +8529 6 24.903 37.9158 30.7914 -43.8554 -5.41491 21.3724 +8530 4 23.952 37.804 31.173 48.4757 4.96182 -14.1951 +8531 4 24.7905 38.4252 29.9913 -4.69729 3.46822 -12.8277 +8532 6 2.22055 5.32897 16.4318 -0.704957 11.5959 2.51569 +8533 4 1.8086 4.56809 16.8519 3.25773 -6.94195 4.1641 +8534 4 3.17492 5.17974 16.3235 -2.45649 -10.6256 -1.35481 +8535 6 1.39662 14.9371 19.1386 6.71081 10.2639 18.1623 +8536 4 0.558182 14.6006 18.8448 -10.0768 -10.7254 -15.2923 +8537 4 1.25744 14.8844 20.1022 8.06638 5.64899 -3.4629 +8538 6 34.3184 26.5435 23.7018 12.956 38.2174 -10.8067 +8539 4 33.6096 26.6326 23.0506 -6.28704 -5.42218 7.19498 +8540 4 34.253 25.729 24.1673 -8.0715 -30.4977 4.91012 +8541 6 41.932 21.8144 37.5476 -28.1346 24.458 10.6264 +8542 4 41.9653 21.2973 38.3662 8.82952 -0.726087 -9.88338 +8543 4 41.2985 22.5209 37.8344 14.7394 -10.5077 -10.9774 +8544 6 39.4289 37.6722 12.6363 -7.06663 36.6798 -8.56095 +8545 4 38.7214 38.0767 13.1674 9.12422 -13.2372 3.4836 +8546 4 39.8791 38.4903 12.2996 -0.376717 -30.7746 7.3995 +8547 6 30.2308 35.8744 2.88429 56.3256 -5.17531 19.584 +8548 4 29.7395 35.078 2.8871 -14.5394 -27.2578 -4.40621 +8549 4 29.6846 36.541 2.55195 -33.266 39.3858 -14.7027 +8550 6 50.3691 12.2996 11.0379 -10.7742 -32.245 -38.7061 +8551 4 50.5492 13.1381 11.4098 4.20277 26.7051 25.7379 +8552 4 50.0731 11.6929 11.7162 -2.05651 -3.66514 15.0978 +8553 6 38.4203 1.52686 34.6552 6.3891 -23.1477 32.9209 +8554 4 38.2942 1.9363 33.8354 -7.66336 30.6162 -40.7111 +8555 4 38.1079 0.632206 34.5078 -6.35148 -11.0336 -1.97829 +8556 6 23.4679 32.2557 29.2149 -43.4567 -12.6916 53.2324 +8557 4 24.0296 32.8423 28.7424 12.6247 17.2837 -9.6693 +8558 4 23.1232 32.6929 30.0761 24.9901 -11.6617 -44.232 +8559 6 36.561 38.8488 8.89417 42.7368 2.70764 46.8348 +8560 4 35.962 39.5202 8.64255 -29.9788 24.4889 -23.0747 +8561 4 36.8832 39.1244 9.78764 -11.193 -6.37855 -17.8717 +8562 6 35.882 15.8491 32.4345 4.38917 24.4094 -11.8898 +8563 4 36.1253 15.4284 33.2547 4.1797 -3.844 11.2859 +8564 4 36.4849 16.63 32.3181 -12.6028 -21.8682 2.29862 +8565 6 22.2747 21.8257 41.5848 1.63659 45.0851 -0.0273952 +8566 4 22.1351 22.8132 41.5538 -4.13496 -33.3395 13.1468 +8567 4 23.0832 21.7834 41.079 15.3069 -18.439 -3.51535 +8568 6 24.3693 38.6933 37.0124 5.99709 22.8296 -9.01594 +8569 4 25.2224 39.1901 37.0147 -13.2325 -18.2305 -0.0611307 +8570 4 24.4452 38.0141 37.6805 1.8393 -10.9749 7.25289 +8571 6 45.85 22.0674 16.0435 -6.35855 -11.009 -33.5755 +8572 4 46.1693 22.2375 15.1223 -5.70657 5.73574 25.2515 +8573 4 45.3177 21.2496 15.9445 13.424 8.98362 5.88408 +8574 6 34.0938 26.1451 39.6028 29.3502 -8.72422 32.5359 +8575 4 33.1775 26.2044 39.4639 -36.6108 3.5864 -15.8394 +8576 4 34.1454 26.1252 40.583 9.60862 3.8872 -14.9166 +8577 6 7.22316 36.161 23.2803 -75.9344 2.48999 -44.2827 +8578 4 7.2061 37.0658 22.9632 2.60813 8.07149 -4.69042 +8579 4 7.98979 36.1134 23.7455 79.8131 -8.28428 52.3852 +8580 6 29.1469 40.7664 9.14908 25.9603 -62.9641 -41.536 +8581 4 29.104 40.2522 8.28913 -11.1672 35.4313 19.904 +8582 4 29.7179 40.1086 9.59652 -3.22944 23.7461 21.8778 +8583 6 29.3725 11.2348 1.3024 -38.7794 14.8627 17.4065 +8584 4 28.4703 11.3821 0.891273 31.6728 -0.63192 16.6295 +8585 4 29.2803 11.4968 2.26097 5.36173 -12.1272 -32.3877 +8586 6 30.9813 3.70043 14.0775 0.393287 -12.1193 -7.6118 +8587 4 31.3533 2.81844 14.3971 -7.37725 32.1126 -17.4345 +8588 4 30.796 3.71521 13.098 8.52465 -17.2224 25.8707 +8589 6 29.7018 15.2871 38.2765 -11.7342 18.5436 -44.4423 +8590 4 30.2882 15.1814 38.9925 24.3773 -7.28175 32.8118 +8591 4 30.1059 15.9805 37.6877 -12.7379 -16.9908 17.8861 +8592 6 36.618 0.316233 29.1564 -1.13478 17.6011 -18.8673 +8593 4 37.4497 0.805382 29.2328 -0.537074 -5.31334 10.7084 +8594 4 36.0611 0.935156 28.6408 3.38103 -20.3125 11.7491 +8595 6 47.6566 0.117823 23.249 5.11875 5.73062 -10.5794 +8596 4 46.969 0.414744 23.8324 -12.4062 9.53281 16.9836 +8597 4 47.4018 41.1354 23.0496 0.315762 -17.3342 0.264415 +8598 6 7.91605 37.1729 29.9478 9.96828 38.7234 29.3851 +8599 4 7.8238 37.3188 30.9485 4.22886 -13.4646 -46.5453 +8600 4 8.48708 37.9472 29.6677 -24.8232 -29.7333 9.09982 +8601 6 38.925 24.2263 12.6374 28.6028 -18.1679 -25.4959 +8602 4 37.978 24.1747 12.7226 -16.6271 -1.4443 2.40459 +8603 4 39.1586 23.5255 11.9538 -9.24307 26.9603 22.464 +8604 6 21.3053 26.2545 36.7859 14.9917 45.9325 1.16 +8605 4 20.8074 25.7232 36.1994 -14.2562 -21.9874 -17.8757 +8606 4 21.6248 25.6951 37.4625 3.91421 -21.0802 23.8691 +8607 6 28.2258 23.3284 24.9888 19.6442 1.87868 9.60148 +8608 4 28.2493 24.0261 25.6588 -3.93467 -3.60043 -2.01642 +8609 4 29.1002 22.8932 25.0573 -18.3502 1.43704 -4.70914 +8610 6 38.4116 39.5691 14.5896 29.669 -4.24194 25.1928 +8611 4 38.4978 38.8692 15.3261 -6.52385 31.9806 -37.1925 +8612 4 39.2924 40.0897 14.6163 -46.5668 -30.9815 -6.21074 +8613 6 26.0432 5.99751 38.1148 44.5658 1.98351 30.7371 +8614 4 26.452 6.86444 38.1066 -12.5768 15.2327 -11.4433 +8615 4 26.7959 5.51316 38.5398 -27.2991 -6.53191 -16.0548 +8616 6 52.1237 17.2497 22.5073 -27.4301 16.765 14.7973 +8617 4 52.9399 17.665 22.2571 16.5652 5.20466 -11.3284 +8618 4 52.1578 16.3131 22.3678 7.8945 -19.2066 -9.92552 +8619 6 39.5302 30.1999 31.4498 -15.3908 2.56685 75.4769 +8620 4 40.0207 30.5437 32.2484 0.473519 -4.28305 -35.1019 +8621 4 38.713 29.8928 31.926 18.6512 10.8404 -28.7426 +8622 6 19.6503 6.93083 12.7623 15.8343 -24.4908 21.6207 +8623 4 19.8732 6.46228 13.5959 -20.1786 11.9342 -5.76682 +8624 4 20.303 6.55009 12.1776 -0.0209149 2.55819 -14.5973 +8625 6 32.4196 37.4972 40.0987 12.4446 10.4582 -32.0511 +8626 4 32.8186 36.647 40.0719 9.51079 -23.9505 -16.9607 +8627 4 32.1638 37.519 40.9804 -20.9873 13.1856 56.2462 +8628 6 39.7646 0.344956 6.09395 -0.813604 -13.3118 11.6504 +8629 4 40.0929 1.25666 6.05063 3.72657 -6.06719 5.14874 +8630 4 40.1279 41.7919 6.88268 -2.2039 13.7644 -10.8213 +8631 6 28.7754 10.1494 29.1547 6.27663 8.45441 -17.0952 +8632 4 27.8341 10.1814 28.9557 -5.13507 -0.906004 3.81537 +8633 4 28.9096 9.91312 30.0774 -3.02611 -6.60467 -0.689697 +8634 6 28.3509 21.0738 10.6423 20.1214 -0.517468 -23.7169 +8635 4 28.7452 21.9678 10.604 -10.1652 -7.70852 11.001 +8636 4 28.9796 20.5469 10.1008 -17.263 7.26144 14.8814 +8637 6 27.0689 28.6853 20.8654 35.4789 -5.63144 4.47554 +8638 4 27.7442 29.2307 21.3162 -7.53329 -4.62114 -3.00727 +8639 4 26.2324 28.9644 21.1916 -29.8949 8.87289 15.491 +8640 6 39.6884 13.9755 33.4499 14.6401 2.99861 16.5486 +8641 4 40.0373 13.7827 34.3426 -3.85296 -1.51256 -14.2832 +8642 4 38.7457 13.8219 33.5285 -9.87208 -9.87778 -3.27097 +8643 6 25.4679 11.6581 34.316 -5.2989 -28.5582 40.5924 +8644 4 24.7613 11.1605 34.7897 20.9725 -0.466275 -6.59756 +8645 4 25.003 12.0579 33.6214 -16.717 25.3404 -32.2266 +8646 6 27.5101 37.647 21.4263 -39.7295 -31.2682 -35.969 +8647 4 28.2375 37.1633 21.0518 17.2189 -6.02702 -9.55939 +8648 4 27.8241 38.1534 22.1272 30.3423 24.6719 41.8853 +8649 6 30.5838 20.0489 28.6446 73.221 13.9737 -1.42059 +8650 4 31.1441 19.3945 29.1273 -28.9524 12.9537 -8.0961 +8651 4 29.6632 19.9528 28.6439 -45.0502 -19.2043 6.90743 +8652 6 42.3833 1.8554 14.9243 13.367 3.08275 38.4467 +8653 4 41.8907 2.29225 15.634 5.99337 6.74303 1.17955 +8654 4 41.7769 1.84183 14.2131 -17.6385 -4.20156 -32.9301 +8655 6 12.1633 12.5377 19.5325 -23.0245 -19.867 -11.1113 +8656 4 12.9521 12.0237 19.3369 9.43068 0.576721 5.46819 +8657 4 11.4219 11.8853 19.4518 12.4737 16.4774 1.27947 +8658 6 19.216 1.20416 16.3541 12.5689 2.54581 22.2585 +8659 4 19.6937 0.628292 16.9879 -4.91383 6.35485 -14.1526 +8660 4 19.7889 1.98236 16.2594 -2.22189 -4.72354 -7.2618 +8661 6 9.47695 16.1439 27.6873 23.0793 15.684 -40.8775 +8662 4 9.87411 15.9669 26.7875 -8.00596 11.4199 30.6292 +8663 4 9.27844 15.2819 28.0019 -12.6146 -24.0632 14.4486 +8664 6 40.4558 26.1873 24.7848 -5.87099 -8.07067 -10.9608 +8665 4 40.3772 26.6753 25.6381 -3.45584 0.121614 -18.2296 +8666 4 40.075 26.6842 24.0102 9.21367 0.234889 33.0434 +8667 6 47.6742 17.6493 18.027 -37.0889 26.6143 -3.73366 +8668 4 48.2089 18.0323 18.7522 -4.76487 -3.2939 -8.20899 +8669 4 46.8388 18.2201 17.9217 41.9344 -19.3622 12.4897 +8670 6 36.6073 25.2802 4.19388 18.2149 -9.73143 -24.5863 +8671 4 36.604 25.3887 5.14943 -0.00537736 13.7381 3.83127 +8672 4 37.3627 25.7621 3.76942 -18.9403 0.329358 18.8416 +8673 6 39.5721 35.375 29.6682 7.39129 29.0443 4.37935 +8674 4 38.9992 34.6325 29.7528 -8.39079 -18.7886 -5.10368 +8675 4 39.3389 35.9401 30.4162 6.41301 -4.37294 -4.4287 +8676 6 0.402862 14.6299 13.3406 12.3375 -5.37043 -32.3015 +8677 4 54.737 15.2477 13.6388 -5.18731 7.44473 4.40324 +8678 4 0.540834 14.0191 14.0401 1.19186 -14.994 25.3978 +8679 6 12.2127 27.3484 8.43247 -29.2387 -0.771708 1.75024 +8680 4 12.965 26.7512 8.46983 14.5311 5.0326 6.8656 +8681 4 12.3156 28.1607 8.97491 11.1816 -11.3427 -11.9337 +8682 6 36.8986 14.8167 21.1188 31.0797 27.7575 -31.2238 +8683 4 37.0397 14.394 21.9547 2.6333 -10.7207 26.6181 +8684 4 37.7308 15.3371 20.9125 -24.2604 -24.0664 4.77074 +8685 6 20.8464 4.94114 21.1044 31.4042 5.97012 13.2179 +8686 4 20.3644 5.60924 21.5958 -5.50293 4.43366 -4.7096 +8687 4 21.773 5.03668 21.4416 -23.5272 -13.3128 -11.683 +8688 6 36.7544 1.79945 7.61694 -30.3574 47.6061 45.3867 +8689 4 36.327 2.6686 7.87118 16.8784 -26.1974 -29.8241 +8690 4 36.8428 1.50799 8.53455 15.1793 -22.3797 -11.8231 +8691 6 12.2439 31.5023 37.4569 -32.4985 -2.96535 6.06153 +8692 4 12.7586 31.1596 36.7365 10.4364 1.05198 -9.11954 +8693 4 11.3919 31.0227 37.3953 11.2973 8.58078 9.3944 +8694 6 38.9908 41.586 16.881 -5.73716 8.1645 -10.5856 +8695 4 39.3046 41.7073 15.9766 4.30886 -9.33368 3.06156 +8696 4 39.3667 0.405687 17.3669 3.77504 10.3777 9.96207 +8697 6 31.8904 27.2678 22.2602 -2.97266 4.85738 -46.2508 +8698 4 31.2122 26.6002 22.3915 1.88455 0.488126 10.0993 +8699 4 31.7489 27.4981 21.2895 3.71213 -3.79941 38.8104 +8700 6 42.7405 9.18554 25.589 -22.1194 -12.6454 -9.25487 +8701 4 42.0872 8.82691 24.9599 0.650449 1.17306 7.26361 +8702 4 43.4011 9.54846 25.0154 21.3216 10.0262 -4.62936 +8703 6 50.9383 28.1736 25.3544 -13.6318 0.0171378 28.1732 +8704 4 50.4953 27.5553 24.7803 -5.9639 1.72187 -15.2616 +8705 4 50.5272 27.9992 26.2251 14.2447 5.57945 -12.3971 +8706 6 43.1888 19.6578 30.9105 -66.6531 23.7889 25.5358 +8707 4 44.0873 19.829 30.8982 70.1332 9.75906 -5.84371 +8708 4 42.7965 20.4661 31.3425 9.97757 -17.7871 -10.1322 +8709 6 30.6644 14.0457 40.7997 -18.1309 16.7334 54.243 +8710 4 30.3214 14.3504 41.7092 15.0959 -2.90855 -40.5845 +8711 4 30.1739 13.231 40.7145 -1.19418 -16.8866 -12.4659 +8712 6 20.9131 15.4897 23.0235 5.61878 12.7036 12.8066 +8713 4 20.368 16.1905 23.4302 1.66694 -9.32372 -6.67403 +8714 4 21.8218 15.751 23.2692 -7.37195 -9.57776 -6.18749 +8715 6 34.2171 0.764056 35.8253 8.40959 -35.3498 44.9304 +8716 4 34.6567 1.46863 36.3417 -5.08936 -9.30099 -7.81199 +8717 4 34.1194 41.866 36.4755 2.29033 39.9746 -37.3302 +8718 6 38.9162 36.9098 35.9203 10.0793 6.80115 3.36275 +8719 4 39.7784 37.1612 36.3284 -16.0364 -11.2649 -5.21842 +8720 4 38.6132 36.0588 36.2696 9.66804 2.35098 0.533126 +8721 6 45.1336 25.2146 22.7744 -28.8992 3.863 21.2581 +8722 4 44.1561 25.0943 22.7165 17.1243 8.87651 18.653 +8723 4 45.3983 24.7563 22.0047 17.0602 -12.3694 -29.5411 +8724 6 40.597 0.8134 35.9421 3.227 69.6319 -3.88491 +8725 4 40.5509 41.8059 36.0096 -6.03355 -53.2669 -4.53187 +8726 4 39.9427 1.13471 35.2813 10.0151 -17.6297 16.5691 +8727 6 11.0455 28.3465 35.0235 9.7668 1.71998 -0.601403 +8728 4 10.9819 27.7367 35.7737 -0.960779 4.073 1.47136 +8729 4 10.3922 29.0422 35.1677 -11.8786 -4.48184 3.12795 +8730 6 20.2051 13.5934 35.8566 39.7213 -43.4527 45.4399 +8731 4 19.4813 14.0017 35.4777 -48.9883 30.031 -35.164 +8732 4 20.9868 14.0394 35.5673 14.4182 15.1 -18.5178 +8733 6 39.6245 5.13776 1.76997 -0.951619 9.89005 21.073 +8734 4 38.8252 4.77089 1.41386 -14.9185 -6.12031 -3.7056 +8735 4 40.3018 4.93211 1.13633 15.4903 5.30459 -14.5773 +8736 6 30.2698 30.8736 32.4375 -6.71798 15.6036 14.0469 +8737 4 29.6901 31.1438 33.1751 5.76607 1.99955 -8.25679 +8738 4 29.7896 30.1731 32.0039 1.14172 -17.9152 -6.50707 +8739 6 14.5598 11.0088 22.8703 10.5759 -0.53797 13.7125 +8740 4 15.2344 11.6195 23.3114 -32.0235 -23.0075 -11.5695 +8741 4 13.848 10.7777 23.5118 19.1574 10.2796 -1.34673 +8742 6 20.7379 13.9443 3.00881 5.16887 -45.0314 -26.4616 +8743 4 19.9261 13.6658 2.50706 22.866 18.233 23.793 +8744 4 20.5244 14.6819 3.55007 -16.1173 25.3417 12.2311 +8745 6 41.3029 4.28468 12.6203 -8.04128 10.917 21.7417 +8746 4 40.6152 3.63858 12.7642 -6.82471 -4.23516 2.09603 +8747 4 41.6484 4.11485 11.7651 11.719 -9.67534 -28.974 +8748 6 10.8581 24.7328 21.7161 -39.3585 -15.8792 -33.4515 +8749 4 10.0068 24.8598 21.1989 28.1112 14.2693 20.1969 +8750 4 11.1639 23.9123 21.3137 10.3572 -6.50453 7.69671 +8751 6 53.5762 20.8825 34.3773 -29.6915 -0.0415475 -3.94304 +8752 4 54.5085 20.795 34.3185 33.8519 4.29786 -2.30511 +8753 4 53.2552 20.0612 34.7861 8.83511 12.9473 -9.59804 +8754 6 14.8838 4.84499 30.449 -1.65326 0.839716 -13.8987 +8755 4 14.8578 5.00753 29.4799 -4.93385 -7.75961 17.951 +8756 4 14.5437 3.94124 30.5804 2.28716 7.27432 -2.63088 +8757 6 48.9137 37.1159 13.1232 -44.1315 32.6594 -31.0851 +8758 4 47.9268 37.1149 13.1949 24.5681 4.85746 10.1076 +8759 4 49.2024 36.4546 13.7037 17.9017 -30.2536 24.0784 +8760 6 26.8017 19.3068 7.5379 -15.1037 -1.6612 14.6377 +8761 4 27.3245 18.5243 7.34583 -2.01051 -6.65035 -9.19035 +8762 4 27.3053 20.0577 7.2492 18.4232 10.5976 -10.0514 +8763 6 17.631 11.9383 39.0904 -43.3265 13.8677 10.122 +8764 4 18.4941 11.6307 38.9203 38.4816 -13.6738 2.54756 +8765 4 17.5009 12.0978 40.0481 6.31677 -1.58465 -10.4285 +8766 6 49.9233 14.5931 8.61354 5.83785 -36.2985 -8.08798 +8767 4 49.214 13.9285 8.60404 6.89175 6.08198 5.75816 +8768 4 49.5175 15.3796 8.93642 -5.42274 33.9852 6.11405 +8769 6 32.3642 34.9667 31.5078 2.95354 23.7899 20.5819 +8770 4 32.072 34.4222 30.8036 -4.84614 -18.7532 -16.6478 +8771 4 32.4643 35.8463 31.1217 -0.970967 -0.757054 5.3462 +8772 6 11.8286 22.2266 21.3061 -17.2258 -15.6378 -41.9552 +8773 4 12.2171 21.6669 20.5638 -11.8041 19.7065 26.8676 +8774 4 12.3859 22.1258 22.0497 29.6948 -3.02551 21.8379 +8775 6 33.8509 9.96106 13.6416 -14.3875 -24.3714 -53.1057 +8776 4 33.0123 9.50508 13.4028 8.15621 17.9807 22.2309 +8777 4 34.3201 9.78154 12.7883 7.50726 12.1846 28.7729 +8778 6 25.5192 36.3946 1.51103 -10.4602 3.19395 -11.4439 +8779 4 26.0842 36.7323 0.810141 8.62195 6.50952 5.56913 +8780 4 24.6933 36.9065 1.40961 6.72848 -10.059 1.65156 +8781 6 26.2721 10.5411 9.76409 -19.2005 -4.19702 2.88354 +8782 4 25.6096 11.193 9.42675 5.9346 -6.99241 18.1855 +8783 4 25.839 9.94226 10.4354 7.43867 25.8511 -14.7334 +8784 6 25.016 0.794303 40.8954 13.3669 6.17095 4.00755 +8785 4 25.3682 0.342397 40.1084 -6.19889 9.04785 1.09472 +8786 4 25.4075 1.69244 40.9338 -2.19893 -14.7289 -5.24662 +8787 6 46.2434 3.93626 24.8203 6.94819 -22.6825 -8.03363 +8788 4 46.3834 4.04208 23.8743 3.61713 6.01616 -2.12387 +8789 4 46.2394 2.96647 24.9181 -8.37252 7.22853 3.62774 +8790 6 21.5889 13.6037 29.2057 4.95103 8.76674 17.4208 +8791 4 21.6019 14.3052 29.8879 -2.51331 -9.966 -5.68557 +8792 4 21.3126 14.082 28.4253 -2.16645 0.501775 -6.52993 +8793 6 36.7737 38.3803 0.360926 -13.0762 -25.442 -6.6792 +8794 4 36.4499 39.0355 0.978203 -4.80976 12.188 0.88021 +8795 4 36.0266 37.7487 0.22189 15.835 12.8395 4.19355 +8796 6 19.3086 17.6338 24.0617 47.0109 35.6134 -17.5995 +8797 4 18.4263 17.3722 24.1632 -50.3154 -15.1751 2.93786 +8798 4 19.3137 18.3511 23.365 -2.62926 -22.9616 14.087 +8799 6 23.1803 12.6945 3.50697 -12.4047 4.12184 -0.296296 +8800 4 22.2521 12.9621 3.30307 10.5621 -3.58256 -0.535563 +8801 4 23.3663 11.8631 3.0578 -9.23841 -1.30096 -1.53094 +8802 6 37.8891 8.88353 35.4651 -18.9945 -25.3999 -47.3866 +8803 4 38.8166 8.83127 35.1934 2.77199 2.98421 7.2207 +8804 4 37.4068 8.32521 34.752 23.9265 29.6152 37.0755 +8805 6 14.3237 15.1253 36.1844 10.7536 -1.62675 -12.1114 +8806 4 15.0418 15.7291 36.3902 7.37284 -3.65767 0.0646607 +8807 4 13.765 15.154 36.9379 -17.7819 2.51157 18.8211 +8808 6 35.0801 0.941274 33.018 -10.8249 30.7834 33.3167 +8809 4 34.9269 1.883 33.2395 6.71896 -7.58638 -28.1375 +8810 4 34.9733 0.615676 33.9226 0.339269 -19.4543 -11.259 +8811 6 50.9271 0.518298 17.9933 -4.01299 -8.33658 -1.61011 +8812 4 50.7551 1.39133 17.5891 -0.713529 -12.5397 8.99793 +8813 4 50.17 41.8323 17.8017 14.8721 13.6567 -6.57092 +8814 6 26.2328 30.5636 0.934374 -8.95911 39.2037 50.9017 +8815 4 26.9657 31.1139 1.27364 -12.5333 -13.1029 -5.86431 +8816 4 26.5352 30.0815 0.207089 19.4446 -20.9762 -37.1203 +8817 6 18.5681 38.3031 4.5613 16.0408 -0.4472 -12.493 +8818 4 17.6336 38.3732 4.40187 -16.7548 5.85511 1.82222 +8819 4 18.9561 38.7121 3.75593 -0.616515 -6.35836 15.3023 +8820 6 31.1349 5.07457 4.1166 35.5071 -12.4218 -11.0008 +8821 4 31.9258 4.61163 4.53765 -37.2933 13.7034 -13.5003 +8822 4 31.2792 5.02565 3.1391 -9.10044 -1.2591 17.9933 +8823 6 26.4378 21.892 1.49191 0.117022 -23.7737 9.75083 +8824 4 26.3504 22.7277 1.07049 4.38069 30.3527 -12.7348 +8825 4 27.3618 21.6023 1.50897 -0.762137 4.81239 -9.09803 +8826 6 39.2154 11.7026 22.7855 15.1366 1.14561 24.1899 +8827 4 39.8619 11.6546 23.5153 -3.42244 7.72178 -8.31759 +8828 4 38.7922 10.855 22.8508 -11.0077 -10.6036 -7.38167 +8829 6 13.6049 36.3215 30.6697 16.8779 70.0034 -37.8159 +8830 4 13.9417 37.1302 31.1268 -10.116 -30.1168 -5.71441 +8831 4 13.4922 35.6039 31.2515 -3.36872 -19.2676 30.0327 +8832 6 50.5831 9.86782 9.34675 -39.9446 -18.2052 0.719337 +8833 4 49.679 9.5553 9.65542 27.7691 6.62521 -8.8993 +8834 4 50.7343 10.6656 9.84378 7.47556 12.1458 9.31829 +8835 6 49.6659 40.3022 22.5839 -5.95569 -23.2057 2.00246 +8836 4 49.9088 39.3695 22.3976 1.04597 17.1639 -6.42107 +8837 4 49.3089 40.2511 23.4853 9.00681 3.37443 -0.55643 +8838 6 7.21026 41.318 28.8937 -13.882 28.5523 32.2899 +8839 4 7.13277 41.6426 29.851 5.74914 -19.7174 -37.6289 +8840 4 7.14599 0.215754 28.3517 11.7183 -8.26627 3.5395 +8841 6 13.0317 18.008 25.3351 57.1177 45.3919 41.6622 +8842 4 13.702 18.0765 24.6297 -18.9881 -2.87884 -2.05071 +8843 4 13.5608 18.5052 26.1022 -41.5403 -41.2906 -37.5185 +8844 6 50.0508 19.5822 2.43378 8.05757 -12.3534 -25.4868 +8845 4 50.6415 19.2321 1.70522 -9.91294 15.3245 28.3035 +8846 4 50.4964 20.3068 2.88656 9.48594 2.0046 -2.18375 +8847 6 28.3417 40.9623 24.5247 28.1527 -9.28969 -2.11238 +8848 4 28.8808 40.6229 23.7869 -8.53201 1.00989 5.926 +8849 4 27.851 41.6822 24.1702 -24.0642 17.3603 -12.6153 +8850 6 19.4173 5.36544 29.5282 -16.7292 -1.42659 17.4998 +8851 4 20.0576 6.03033 29.2802 12.6037 1.87093 -5.71578 +8852 4 18.8017 5.84191 30.1159 0.735032 -8.12986 -7.95209 +8853 6 35.3107 40.1454 22.2712 -2.40765 19.7984 -7.699 +8854 4 35.7006 39.9699 23.1142 6.54418 -16.9762 14.0951 +8855 4 35.2702 41.1078 22.294 -0.592679 0.794763 -5.20647 +8856 6 16.1889 33.7724 9.7458 10.3229 10.2088 29.582 +8857 4 15.8959 33.2543 9.01299 -6.07516 -13.8809 -16.7379 +8858 4 15.6715 34.5759 9.82028 -7.73583 2.776 -7.11592 +8859 6 17.3675 40.6445 20.2267 0.0256395 24.2963 -9.09373 +8860 4 17.2094 39.7816 20.6122 1.5629 -5.58702 6.23448 +8861 4 17.4758 41.3298 20.9152 1.51783 -13.2527 0.49298 +8862 6 20.5171 9.72867 9.58726 35.059 7.05341 -25.1666 +8863 4 21.2226 9.96362 10.213 -13.2653 -0.810893 -5.91795 +8864 4 19.8248 9.38464 10.113 -26.7953 -13.816 19.6743 +8865 6 47.4426 20.1922 21.3765 55.2231 -18.8128 34.629 +8866 4 48.295 19.6294 21.3384 -41.3243 22.9169 -3.74061 +8867 4 46.9816 20.0754 20.5659 -14.9725 -5.50706 -31.0177 +8868 6 38.4071 40.79 37.8146 12.3234 -22.6201 -9.80787 +8869 4 38.1404 41.7017 37.8605 -3.64711 23.1989 -4.06141 +8870 4 38.2696 40.4362 38.6954 -10.1247 -0.131598 9.15413 +8871 6 4.78578 1.94641 13.1038 0.280311 5.55092 -8.42179 +8872 4 4.79931 1.2475 12.4246 2.88607 5.75183 11.0778 +8873 4 4.58324 1.57529 13.9639 -2.31824 -10.9024 4.61034 +8874 6 46.8249 29.0091 2.16845 3.76482 2.94797 40.2579 +8875 4 46.7332 29.1215 3.14399 -15.0191 0.321828 -28.5005 +8876 4 47.6691 28.5689 2.15078 10.7116 -9.65214 -17.1948 +8877 6 37.4359 26.1653 25.6478 9.30824 1.4869 -5.75173 +8878 4 37.1837 25.5346 26.3178 -5.80587 -7.25577 3.90549 +8879 4 36.6384 26.5534 25.3025 -7.59782 4.42715 -0.0787482 +8880 6 27.3269 4.19583 19.442 5.96538 17.8772 -24.7701 +8881 4 28.0114 4.58146 18.8428 -3.77368 -14.8915 15.8068 +8882 4 26.5277 4.61529 19.0816 -6.14884 -6.84507 9.70558 +8883 6 29.57 35.1706 32.6629 9.65469 -19.4491 -13.9626 +8884 4 29.5306 34.4116 32.0191 -0.1659 24.8691 21.1709 +8885 4 30.4743 35.5004 32.5856 -0.51053 -0.290213 -2.43375 +8886 6 51.6097 27.3863 34.6091 -31.2455 30.913 9.06642 +8887 4 51.929 26.6019 35 16.42 -40.5282 7.55135 +8888 4 52.0725 27.582 33.8009 7.9649 -1.59603 -13.3915 +8889 6 26.2078 15.7281 22.6941 16.538 -21.7488 31.7554 +8890 4 25.9667 16.5615 22.3191 -8.70869 23.0893 -12.8942 +8891 4 26.0629 14.9994 22.0993 -9.54979 -3.97748 -17.7982 +8892 6 36.1239 41.1986 15.4707 -7.45359 -19.8962 -4.3143 +8893 4 35.6999 40.3419 15.2987 -9.47391 11.3121 -0.409552 +8894 4 37.0386 40.9374 15.4513 15.7433 3.85103 -0.545832 +8895 6 18.465 8.81345 11.2165 5.38391 10.0618 1.17025 +8896 4 18.7987 8.15135 11.8182 8.53154 -1.35082 11.1952 +8897 4 17.7161 8.38168 10.8393 -16.7411 -2.38381 -11.2186 +8898 6 30.2088 21.3096 23.2049 -11.6688 7.62645 -9.73036 +8899 4 29.9671 22.1993 22.9248 4.97058 -0.914249 3.78278 +8900 4 29.5299 20.7541 22.7893 7.94877 -1.13118 2.47612 +8901 6 22.73 2.20521 34.8374 1.74432 -25.8699 49.3747 +8902 4 22.3572 1.29354 34.8889 6.16039 22.5731 -10.8251 +8903 4 22.7018 2.4887 33.9486 -6.75325 10.5307 -40.1895 +8904 6 12.6909 2.75059 12.3422 -14.3125 16.3183 -13.6311 +8905 4 12.533 3.61796 11.8786 11.7453 -23.2619 14.9881 +8906 4 13.1336 2.19907 11.6816 1.83842 1.45343 3.2847 +8907 6 24.107 30.0639 14.5719 -73.5796 11.8292 4.65098 +8908 4 23.699 30.7611 15.1345 32.1371 -0.343623 -0.31889 +8909 4 23.2337 29.7156 14.2286 43.085 -3.68866 -7.89372 +8910 6 0.015177 27.9048 22.8533 -2.756 -4.53229 -2.63487 +8911 4 54.6492 28.3778 23.623 -8.36257 -3.01834 -6.1652 +8912 4 54.216 27.6514 22.3224 8.23112 8.70814 10.2495 +8913 6 12.3617 4.4844 25.9108 40.9735 -25.7794 -17.3291 +8914 4 12.201 5.40791 25.8162 -22.6464 21.2272 1.21762 +8915 4 11.6198 4.00067 26.267 -15.5784 4.93476 10.9426 +8916 6 50.6578 14.4652 5.91353 -13.9437 -6.30553 43.3918 +8917 4 51.4397 15.014 5.76935 2.55266 2.90763 -3.8133 +8918 4 50.4787 14.4827 6.92851 9.15248 3.54798 -49.9389 +8919 6 52.5668 22.873 20.1428 -12.6564 -29.9263 -28.8801 +8920 4 52.956 23.3393 20.8718 4.45243 13.9606 14.107 +8921 4 52.7899 23.3428 19.3246 -0.129831 10.341 11.583 +8922 6 43.5892 16.524 12.8775 29.595 -3.78245 -19.1347 +8923 4 44.3058 16.0087 12.3806 -28.6005 27.9094 23.6723 +8924 4 42.7982 16.4888 12.3437 -11.2315 -8.54457 -10.2035 +8925 6 15.9661 16.7487 40.5866 1.44034 32.7745 -1.20572 +8926 4 16.4126 17.3388 39.9207 -12.1014 -18.8104 17.452 +8927 4 15.5985 17.3766 41.2587 12.5036 -14.614 -16.5617 +8928 6 23.4158 18.8712 23.8473 -16.0774 -11.4939 3.2157 +8929 4 23.4518 19.2692 24.728 -0.157295 3.62127 -3.85719 +8930 4 22.4941 18.9757 23.5436 12.0607 -0.266031 2.57498 +8931 6 46.4178 3.27548 31.8952 19.5415 -1.29071 -17.2416 +8932 4 45.5866 3.26999 31.4067 -8.61336 -0.166695 4.01481 +8933 4 46.2657 3.3297 32.8359 -5.35267 1.32166 2.09612 +8934 6 43.4045 41.0584 12.2875 -8.04746 -23.5947 4.76735 +8935 4 43.6693 41.8276 12.7696 6.05224 12.9314 10.8988 +8936 4 43.5172 41.2728 11.3626 0.904796 3.93503 -13.2342 +8937 6 7.4976 32.4756 29.5884 -13.7893 55.6862 -12.0377 +8938 4 8.07142 31.7837 29.8334 27.4303 -26.9633 6.13269 +8939 4 8.04212 33.3166 29.512 -13.0153 -27.2422 -1.65156 +8940 6 4.77821 31.644 22.4997 2.28771 28.4048 16.4959 +8941 4 5.27411 32.2412 23.0928 2.56389 -13.4484 -8.63656 +8942 4 4.12057 32.2584 22.1518 -1.39427 -10.0394 -7.16978 +8943 6 48.879 26.8662 2.67919 -5.86075 -60.7959 24.9619 +8944 4 49.7001 26.7095 3.23946 -26.2991 7.4186 -32.0291 +8945 4 48.3448 25.9902 2.75892 28.4546 51.6452 -6.88552 +8946 6 35.3626 23.261 21.6242 -2.7789 -2.57103 6.54281 +8947 4 36.2261 22.8974 21.81 4.94258 -15.6751 6.88864 +8948 4 35.5426 23.9136 20.9639 -1.02428 17.548 -23.8062 +8949 6 9.79934 37.7758 27.3048 16.52 16.637 17.9603 +8950 4 9.72643 38.6113 27.803 -16.1555 -8.36248 -12.7831 +8951 4 10.5885 37.4189 27.7206 -2.15823 -16.4776 -5.60851 +8952 6 6.95685 10.9812 25.9821 -25.178 -21.2877 -4.97438 +8953 4 6.33357 10.2528 25.7268 23.179 21.9129 0.503821 +8954 4 7.29095 10.6974 26.8328 9.60603 -1.481 14.6966 +8955 6 15.9965 34.4888 38.9273 -2.91878 -3.91161 19.3063 +8956 4 16.0374 33.5463 38.7461 4.95306 -0.665665 -16.4822 +8957 4 15.9715 34.4958 39.9054 -7.59103 5.72172 -22.2107 +8958 6 24.1167 17.3197 36.1615 15.3363 -47.5124 0.380375 +8959 4 24.7173 17.5753 36.8648 1.58194 5.49031 12.5141 +8960 4 24.1546 16.3101 36.2205 -9.7187 30.8811 -7.11116 +8961 6 29.9757 19.0472 5.63639 12.788 -31.6225 11.2379 +8962 4 30.1584 18.5328 6.46799 -12.7316 12.501 -21.5451 +8963 4 29.4206 19.7916 5.84051 -11.4929 16.6696 15.0892 +8964 6 41.2293 14.2018 25.873 -1.75888 28.9255 -23.3251 +8965 4 41.1078 15.0995 25.4693 3.83492 -22.0907 13.098 +8966 4 41.2654 14.3268 26.8215 3.7207 5.50516 9.94654 +8967 6 30.6006 17.7874 37.3562 -24.7598 46.8721 10.074 +8968 4 30.0173 18.4181 36.8416 23.2796 -25.9316 -1.25214 +8969 4 30.633 18.2764 38.2118 8.15578 -14.795 -8.30511 +8970 6 36.2662 35.7599 28.8527 -12.8707 -30.9202 21.2821 +8971 4 36.6718 34.9534 29.2396 -10.1595 12.442 -4.1956 +8972 4 37.0218 36.2801 28.6478 17.3511 22.2532 -11.5483 +8973 6 0.195836 37.8645 20.3851 -23.6217 6.21569 -13.9532 +8974 4 0.549498 37.2778 21.0637 4.94615 -2.95215 -2.70832 +8975 4 54.3862 37.4234 20.0075 16.4722 8.11718 6.90773 +8976 6 49.5165 39.5896 25.2714 -0.622408 -34.3922 32.9891 +8977 4 49.1772 39.7667 26.1925 10.9208 -1.11318 -32.3029 +8978 4 49.8261 38.6352 25.2806 -10.9036 35.658 1.81375 +8979 6 21.6574 10.1952 29.3538 -5.06277 -0.743802 10.2318 +8980 4 21.4664 11.1105 29.223 -3.01111 19.5458 -20.3057 +8981 4 21.662 10.2064 30.3052 9.73006 -17.7161 13.8831 +8982 6 36.4636 30.0567 0.119709 9.37859 61.6807 38.5429 +8983 4 36.3123 29.4684 41.3206 -1.21017 -23.1836 -37.505 +8984 4 36.9143 30.908 41.7057 -13.4567 -39.5067 4.20368 +8985 6 35.2344 23.3726 39.1433 31.8417 -88.9919 -51.9106 +8986 4 35.0278 23.5012 38.2069 -5.96056 -5.38998 8.96032 +8987 4 34.9909 24.127 39.538 -31.8308 96.9265 45.0865 +8988 6 25.4761 17.6258 38.7257 1.29934 8.28965 -16.1346 +8989 4 26.2031 17.0769 39.0234 13.7946 -6.33455 1.86524 +8990 4 25.7107 18.4933 39.0598 1.3782 7.33891 4.86011 +8991 6 32.6846 1.71002 15.3734 -11.6254 -20.3205 21.5399 +8992 4 32.9453 1.93093 16.3086 -8.96834 -8.53877 -20.2534 +8993 4 32.154 0.853232 15.3925 19.204 32.1949 4.36426 +8994 6 2.7574 26.2382 40.1716 -4.40087 -21.6692 -50.7652 +8995 4 2.38718 26.7949 40.8139 -8.13358 26.7101 38.7547 +8996 4 3.41358 25.6429 40.5298 13.0891 -5.49009 7.80053 +8997 6 25.4307 39.5752 6.64887 -26.4755 -1.32722 14.1102 +8998 4 25.8932 39.0809 7.30961 27.038 -6.17916 -3.25304 +8999 4 24.5458 39.4465 7.03066 -2.44587 12.932 -21.9634 +9000 6 3.88975 2.45855 21.1879 28.3389 -91.355 -25.6726 +9001 4 3.44478 1.54109 20.9736 25.4092 48.4753 9.01111 +9002 4 3.19228 2.99847 21.4284 -47.2055 43.8768 12.3888 +9003 6 19.4353 35.9908 6.17834 -1.98144 -11.1023 18.0698 +9004 4 18.7425 35.7628 6.83514 2.39623 12.5316 -16.1317 +9005 4 19.0828 36.5127 5.45195 -11.0597 11.4176 1.1294 +9006 6 53.664 10.8386 34.7899 -0.427116 -3.27611 41.7292 +9007 4 53.6105 10.6836 35.7561 -1.66612 -17.5448 -26.7849 +9008 4 53.9652 11.7272 34.8329 4.68725 29.9217 -18.2793 +9009 6 51.2799 14.0867 34.6651 -29.2798 -10.9719 -23.3019 +9010 4 50.6522 13.5411 34.1107 26.8684 18.9114 5.01949 +9011 4 50.9895 13.8814 35.5479 1.81167 -5.08277 17.6681 +9012 6 14.4338 40.0198 28.0288 -0.147098 23.5255 27.6002 +9013 4 13.7688 39.3521 27.8218 1.28331 -8.25373 7.75106 +9014 4 14.1948 40.5222 28.8704 -0.878391 -19.6822 -29.209 +9015 6 36.0552 40.8569 1.29319 48.4065 13.1893 15.2608 +9016 4 35.4421 41.0883 1.96787 -21.4185 -0.412662 13.5205 +9017 4 36.896 41.2683 1.66088 -27.5471 -12.7345 -18.5843 +9018 6 32.5846 21.8706 9.62772 14.4951 6.80277 0.680584 +9019 4 32.1936 21.3098 8.97285 -7.2875 -23.9506 -7.81502 +9020 4 32.858 22.6104 9.08324 0.955029 10.0343 1.40437 +9021 6 53.7602 11.4574 10.0748 -7.70253 -4.89045 -17.0247 +9022 4 54.6558 11.7035 10.3272 3.70339 -10.2166 -5.16833 +9023 4 53.8328 10.8374 9.31644 -2.27357 5.83713 13.9933 +9024 6 25.443 2.0669 35.0212 -16.7533 17.7231 -21.4763 +9025 4 25.6415 2.91576 34.5502 -7.64634 -16.7974 11.4347 +9026 4 24.4652 2.09352 35.1703 17.3945 -2.11295 -4.26167 +9027 6 38.4088 16.3775 27.0777 23.4896 -26.556 7.92078 +9028 4 38.4029 15.905 27.9411 -0.72651 18.7119 -5.4255 +9029 4 38.1233 17.2789 27.1678 -4.67214 15.3602 11.0072 +9030 6 11.9834 11.8283 38.0863 1.50515 -20.9897 -19.5245 +9031 4 12.337 12.445 38.7318 -5.05033 4.06408 7.46746 +9032 4 11.0493 11.6049 38.244 7.06215 11.5652 6.68382 +9033 6 21.1646 40.7247 25.8949 30.8575 -6.32012 -20.5276 +9034 4 20.7152 41.4784 25.5554 -14.4662 20.9939 -18.0031 +9035 4 20.8194 40.6451 26.758 -13.9443 -15.9826 36.5019 +9036 6 5.45737 31.2526 28.1092 12.1805 15.5126 -2.48606 +9037 4 4.77986 31.7446 27.6301 0.776808 -0.764161 -8.53258 +9038 4 6.21204 31.8695 28.2031 -7.61365 -6.18966 7.74582 +9039 6 38.5666 10.4345 26.6322 12.4833 -8.23035 1.5222 +9040 4 39.2815 10.9281 26.2104 -2.91177 1.8082 -0.00903947 +9041 4 39.0293 9.89744 27.2937 -7.88948 5.75886 -1.98766 +9042 6 34.5704 22.2441 5.77364 -5.35359 -6.12765 6.5276 +9043 4 33.6261 22.329 6.01336 10.9983 8.59631 1.2651 +9044 4 35.1361 22.6291 6.46875 -10.1328 -5.43064 -4.61746 +9045 6 19.508 23.4157 8.91293 -5.78488 4.73981 5.04963 +9046 4 19.7274 23.1974 9.83518 1.16663 -6.94775 -9.92836 +9047 4 19.9131 22.8043 8.29809 9.12387 -6.1547 2.91491 +9048 6 19.7424 39.1606 18.9462 6.36032 12.2479 8.14591 +9049 4 20.3561 39.0422 19.6872 -3.85164 -4.35394 -5.20149 +9050 4 19.0738 39.7495 19.3414 -1.06489 -8.07777 -11.9442 +9051 6 19.0057 16.6591 37.8853 37.3334 -16.7993 4.17439 +9052 4 18.1861 16.4809 37.4823 -32.8062 -2.38488 -19.1553 +9053 4 18.8146 17.2984 38.5514 -2.10283 15.4454 14.1988 +9054 6 46.1541 18.3125 34.4675 -16.9871 7.29415 15.254 +9055 4 46.1595 17.7325 33.7168 0.615393 -10.1859 -17.2384 +9056 4 45.2376 18.6499 34.5058 9.28079 -5.03019 -2.85447 +9057 6 37.6537 4.93165 10.635 20.1552 -8.04423 -16.7256 +9058 4 38.5399 5.21744 10.272 -26.6503 -7.30776 7.98139 +9059 4 37.1074 4.55852 9.88971 22.9932 21.6332 27.1334 +9060 6 51.9792 36.004 6.8478 30.791 3.18545 -0.726681 +9061 4 52.2413 36.7963 6.35992 -14.9215 -4.55469 -2.53046 +9062 4 52.8266 35.8818 7.33626 -22.3254 6.63746 5.40006 +9063 6 26.6741 12.3268 1.0034 -10.7024 -25.4666 -34.2692 +9064 4 26.4988 12.3574 1.94138 -4.81655 1.43394 14.8604 +9065 4 26.0954 11.585 0.663483 16.9242 17.5219 15.4646 +9066 6 51.3423 35.7724 13.5298 -0.266216 29.5034 10.6004 +9067 4 51.4043 36.4131 12.804 2.34884 -4.4098 -1.45811 +9068 4 51.4073 34.9167 13.1542 5.41074 -27.2154 -15.541 +9069 6 1.98873 3.64285 24.5869 25.9971 69.8048 -55.2188 +9070 4 1.65752 3.03018 25.1632 -30.3002 -46.9535 54.3289 +9071 4 1.71436 4.54846 24.8879 2.6309 -26.2008 -0.982747 +9072 6 33.5221 15.2795 16.4506 0.0536135 -15.838 -38.1617 +9073 4 33.6476 15.3964 15.4593 -8.63578 3.82522 35.1416 +9074 4 33.7341 16.1085 16.8736 8.85342 14.4801 4.37501 +9075 6 10.7227 26.5775 37.3442 -67.903 54.2831 -20.645 +9076 4 10.2191 27.0779 38.0369 14.5194 -13.2702 -3.80745 +9077 4 11.4784 26.2608 37.7268 68.0232 -30.094 41.6962 +9078 6 39.6271 8.38119 31.999 1.44949 -5.13238 35.1009 +9079 4 39.1996 8.85287 32.7464 5.61163 -5.5592 -21.3265 +9080 4 39.0885 8.45634 31.2221 -15.3514 9.3045 -12.0182 +9081 6 48.873 24.2439 11.5987 1.10357 -37.2725 -9.21005 +9082 4 49.1825 23.3167 11.4023 -5.65288 27.9965 8.32055 +9083 4 49.5986 24.6511 12.0826 3.19491 3.15896 -2.50749 +9084 6 15.8098 8.51994 22.5326 -12.5814 0.672941 2.19285 +9085 4 15.7588 8.52265 21.5683 10.3815 2.49136 4.36748 +9086 4 15.4206 9.36801 22.7863 6.5895 4.65597 -0.371293 +9087 6 16.9392 23.5364 7.95083 25.1749 21.5498 -34.0775 +9088 4 17.2079 23.9031 7.093 -25.8979 -5.01679 3.50755 +9089 4 17.8126 23.4623 8.29573 16.7216 -7.09478 32.6865 +9090 6 42.4825 26.8555 6.33102 0.60087 7.54144 -12.7632 +9091 4 41.764 27.4892 6.46083 9.75026 1.01062 3.5184 +9092 4 43.14 27.3488 5.78659 -9.42643 -3.33158 7.6404 +9093 6 36.8078 4.79995 30.0438 -4.74249 18.2042 -3.85385 +9094 4 36.952 4.89746 30.9922 3.10706 -1.8894 0.559973 +9095 4 36.294 4.02131 29.8808 -10.4691 -15.4659 3.71438 +9096 6 45.6128 11.6142 3.31163 15.5246 21.1623 13.6733 +9097 4 45.8972 10.701 3.31117 0.727629 -14.3179 7.30305 +9098 4 46.2501 12.0834 3.90994 -13.3278 -10.7206 -15.6492 +9099 6 24.8943 36.3842 21.2731 0.145584 -0.0155718 21.9832 +9100 4 24.5073 36.3627 22.1568 -5.92138 3.86098 -2.91089 +9101 4 25.79 36.6624 21.4916 7.30899 1.2523 -13.3669 +9102 6 31.8172 24.7218 2.44079 24.9542 32.077 -0.738567 +9103 4 31.5948 23.8911 2.82575 -7.26237 -24.1795 3.52598 +9104 4 32.7966 24.7848 2.51706 -20.2581 -1.29655 -5.98664 +9105 6 24.135 21.9795 37.225 -18.6422 57.7065 19.5247 +9106 4 24.1223 22.9841 37.1061 1.06209 -41.2434 9.50937 +9107 4 24.7129 21.6948 36.5371 13.1815 -12.7877 -24.1492 +9108 6 37.1979 11.5342 15.06 20.8972 -17.7328 -40.5152 +9109 4 38.0246 11.7972 15.4709 -1.33045 5.21986 19.7962 +9110 4 36.429 11.9138 15.4438 -18.178 22.6449 25.793 +9111 6 36.4751 20.3399 41.7845 -26.5497 -48.0551 41.2862 +9112 4 36.3228 19.4621 41.3748 1.60744 11.8178 -3.29004 +9113 4 36.9246 20.873 41.191 27.5593 28.4699 -43.2619 +9114 6 32.0497 37.9214 32.6612 -32.2386 -8.50634 -18.7459 +9115 4 32.4337 38.7163 32.9803 20.8647 20.5609 12.2985 +9116 4 31.3654 38.2694 32.0613 5.31663 -14.2519 5.69849 +9117 6 12.0395 39.928 22.5123 -26.9832 36.7812 23.3187 +9118 4 12.2839 40.8414 22.1926 -3.01474 -29.6796 4.86816 +9119 4 11.2932 40.0883 23.1662 29.524 -10.585 -25.0576 +9120 6 26.3406 1.33526 19.2893 15.6729 -20.8034 13.8388 +9121 4 26.8411 0.655996 19.8199 -14.5491 24.9752 -14.9066 +9122 4 26.8003 2.1813 19.3861 0.112049 0.00336314 -1.02908 +9123 6 5.91669 14.3164 5.69097 2.29729 -16.5161 -30.3395 +9124 4 6.30102 14.1024 4.7902 -6.32478 5.25084 23.5077 +9125 4 5.06552 13.8494 5.70115 7.33482 -6.30923 1.55114 +9126 6 13.3703 23.089 19.1627 -28.3895 15.3871 14.4757 +9127 4 14.1086 22.8122 18.6632 27.2898 -8.01563 -16.6587 +9128 4 13.6991 23.742 19.8005 3.67942 -13.964 0.879599 +9129 6 23.4058 15.0688 9.73621 -4.11719 1.06855 12.2005 +9130 4 22.5732 14.661 10.02 0.657405 4.9462 -7.25364 +9131 4 23.2196 15.7347 9.05868 -5.70535 0.38861 -5.0655 +9132 6 49.5812 13.8288 18.4474 0.101153 1.0527 41.008 +9133 4 48.8214 13.4814 17.9923 -8.96247 -7.71084 -15.1851 +9134 4 50.2052 14.1722 17.8367 10.7879 13.5653 -33.2962 +9135 6 41.7444 5.67096 41.8915 25.5819 0.859229 17.1787 +9136 4 42.5704 5.9364 0.475256 -21.6624 -6.74737 -14.5764 +9137 4 42.0361 4.9893 41.2645 -5.04703 6.59959 -2.77397 +9138 6 17.2492 35.5437 2.55512 -4.98919 17.2489 6.23124 +9139 4 18.1963 35.629 2.41282 7.59523 -3.20753 1.41995 +9140 4 16.9663 34.6563 2.38439 4.57262 -16.6324 -5.73806 +9141 6 49.6936 19.8647 40.242 36.1149 -8.05295 1.41344 +9142 4 49.24 19.0314 40.466 10.1916 2.45634 3.62304 +9143 4 50.6901 19.7225 40.3055 -34.6505 -2.12616 -4.55887 +9144 6 38.3055 5.83107 32.0437 -25.1209 3.13983 17.5072 +9145 4 37.8566 6.51058 32.5952 5.57321 -12.5864 -8.78808 +9146 4 39.2068 6.11217 32.0045 20.6085 6.27671 -1.8315 +9147 6 16.2656 6.85278 34.0134 13.6308 -7.44031 -0.955967 +9148 4 16.5278 6.7006 33.1016 -0.686465 1.61317 -6.98637 +9149 4 17.0706 6.57794 34.496 -11.7464 5.49098 9.02554 +9150 6 33.6779 18.1919 10.4599 39.833 -25.9405 -6.08719 +9151 4 34.2274 18.843 9.984 -7.48822 -11.4027 6.26591 +9152 4 34.2403 17.3374 10.5556 -30.6671 44.9369 -7.76686 +9153 6 38.8896 33.7563 36.7672 22.7659 10.9801 -36.8997 +9154 4 38.4264 33.5452 35.9055 8.66825 7.19978 21.2858 +9155 4 39.8358 34.0039 36.5278 -27.7603 -15.0244 3.77145 +9156 6 45.3747 13.0912 20.2115 -8.54575 18.1695 38.2532 +9157 4 45.1986 12.6554 19.3957 -4.2418 -14.8759 -23.2281 +9158 4 44.5273 13.1029 20.6991 7.89471 -4.73094 -13.0554 +9159 6 36.3919 32.2126 8.83938 1.15121 -2.28434 -1.4136 +9160 4 36.3207 31.3933 9.34391 1.93757 3.36082 7.91897 +9161 4 36.0586 32.9456 9.38554 -3.10773 -8.06217 -4.51958 +9162 6 7.93399 27.8164 6.18652 -8.84441 8.26416 -30.5327 +9163 4 8.20753 27.2416 6.88401 9.15323 -7.03573 14.7081 +9164 4 8.30192 28.6748 6.41842 -5.04409 0.971707 0.751098 +9165 6 14.2889 4.87494 33.6812 -48.074 -5.72289 -27.637 +9166 4 13.5426 5.15568 33.0467 38.2298 -5.02982 23.8683 +9167 4 14.8103 5.65434 33.8518 10.0815 16.0504 2.39638 +9168 6 12.247 8.64363 9.86387 9.5307 8.47707 -42.9656 +9169 4 12.7265 8.83196 10.6522 4.83417 -1.95201 32.3898 +9170 4 11.3733 8.28369 10.003 -7.27928 -7.56138 14.4849 +9171 6 29.7193 31.982 8.5339 -11.3757 5.45371 -22.6092 +9172 4 30.2272 31.7973 9.28681 18.5431 -1.21859 37.4341 +9173 4 29.7513 31.1489 8.05875 -9.95983 -0.182644 -6.87416 +9174 6 22.3912 10.8818 21.4749 22.6973 -30.3469 0.856054 +9175 4 21.7953 11.1177 20.7819 -19.5872 13.8984 -18.5017 +9176 4 22.3568 11.5583 22.1363 -13.7305 16.7548 8.89642 +9177 6 54.1825 27.5382 12.9949 16.0749 -34.873 29.2784 +9178 4 0.169556 27.5337 13.075 -9.84187 5.32432 -2.29215 +9179 4 53.8855 28.25 12.4714 -3.97587 36.1158 -26.3516 +9180 6 7.7322 13.8127 20.037 -51.4252 10.19 -38.2554 +9181 4 8.32211 14.101 20.6974 26.6579 16.8549 28.1402 +9182 4 7.28001 14.6396 19.6917 19.816 -24.9044 7.79538 +9183 6 19.8038 0.841082 24.7751 2.23798 25.7663 18.7115 +9184 4 19.2888 0.974936 25.5977 -1.44078 2.26272 -14.328 +9185 4 20.345 1.66892 24.688 -12.1486 -28.8133 2.35345 +9186 6 3.00622 10.0987 2.94957 -26.3714 23.4248 -9.90714 +9187 4 2.57802 10.9845 2.80681 8.85648 -28.8297 5.38 +9188 4 3.90714 10.2978 3.18407 20.8138 3.7803 5.2 +9189 6 15.8735 13.0135 24.0167 27.3456 -6.4848 -7.35342 +9190 4 15.0397 13.4574 24.067 -14.2007 12.8972 1.61729 +9191 4 16.3075 13.2711 24.8409 -0.511489 -7.63656 -0.0548578 +9192 6 17.0843 4.34635 26.9246 21.6007 -4.50946 14.2865 +9193 4 16.8972 4.2188 26.0046 2.50265 0.324122 -20.691 +9194 4 18.0611 4.2338 26.9976 -18.2314 5.96709 -0.11875 +9195 6 33.6189 39.4094 10.6341 -20.462 51.0085 -28.6484 +9196 4 33.9391 38.663 11.0702 20.9333 -51.253 8.17882 +9197 4 33.8334 39.409 9.67256 -1.15733 -4.02232 18.0774 +9198 6 36.2391 1.10544 13.1071 -14.4853 9.25302 -40.2412 +9199 4 35.5849 0.422507 13.2928 -0.138393 -8.38057 10.5121 +9200 4 36.8138 1.26142 13.8363 9.41155 -3.27129 23.8008 +9201 6 40.853 19.2974 5.10856 37.2457 -28.9827 71.4026 +9202 4 40.5429 19.587 4.3016 -40.6732 16.7295 -57.0845 +9203 4 40.1307 19.0416 5.7147 0.644924 10.2678 -10.4268 +9204 6 2.34714 37.5568 10.1845 35.9634 7.02123 17.8242 +9205 4 3.04769 37.1203 10.7322 -14.847 6.26565 -12.1612 +9206 4 1.86424 36.8893 9.71962 -14.8151 -24.6966 -11.8987 +9207 6 8.10127 29.0413 15.8656 35.302 -29.7249 12.8686 +9208 4 9.00843 28.6191 15.9508 -31.5464 15.4715 -14.0583 +9209 4 8.16404 29.7921 16.4466 -1.11054 13.1495 4.82257 +9210 6 47.3142 26.5199 12.5393 12.6514 34.6971 -22.5506 +9211 4 47.5805 27.2834 11.915 -17.373 -39.4708 28.4474 +9212 4 47.3752 25.7188 12.0092 -0.907674 -0.00416251 -5.94845 +9213 6 33.5917 17.5154 0.659811 -43.6991 -50.8046 22.4668 +9214 4 32.6165 17.4611 0.916402 33.9721 22.4374 -10.1482 +9215 4 33.8023 16.5556 0.790839 15.7196 25.0769 -8.55135 +9216 6 38.9785 15.6005 36.3846 -2.2974 -5.19358 -9.56289 +9217 4 39.1604 14.6481 36.4599 -0.972636 7.263 -3.41001 +9218 4 39.314 15.9159 35.5329 5.29716 -3.31476 -2.44888 +9219 6 34.8185 34.3512 9.36223 6.47638 -43.1481 -28.0847 +9220 4 35.4473 34.9875 9.0418 9.26483 22.2324 -9.2882 +9221 4 34.4241 34.6992 10.1221 -17.9819 29.7233 40.2724 +9222 6 44.963 2.56985 14.7807 31.4374 15.1132 5.36654 +9223 4 44.0324 2.49792 14.9225 -24.9873 -3.38313 6.1219 +9224 4 45.264 3.39221 15.2058 -8.16761 -2.00961 -7.57881 +9225 6 42.6004 38.2794 19.8329 35.0217 22.8895 -33.2683 +9226 4 42.7468 39.1886 19.4383 -9.39889 -30.5105 9.50416 +9227 4 43.174 37.7101 19.2395 -23.2435 10.9907 19.5876 +9228 6 18.6884 26.768 30.2631 -44.5574 -6.69712 -17.565 +9229 4 18.1049 26.7773 29.4546 19.8507 -1.43152 25.0232 +9230 4 19.5658 26.9377 29.9555 24.8572 5.14496 -8.76909 +9231 6 38.8622 37.7231 16.4658 -22.8479 4.5656 13.1257 +9232 4 38.7902 36.7734 16.2818 1.44729 8.74588 -1.32739 +9233 4 39.7766 37.9619 16.5567 26.2519 -3.67716 3.06508 +9234 6 49.2941 9.82087 12.5338 42.2108 35.2088 45.7943 +9235 4 48.9089 9.29765 11.888 -36.0338 -29.0733 -40.4243 +9236 4 48.6148 10.195 13.1058 -6.01968 0.395602 -5.44143 +9237 6 43.2224 7.37144 19.82 -8.13737 3.26926 23.5272 +9238 4 42.5007 7.77471 20.3735 21.5488 -7.79487 -11.5807 +9239 4 44.0862 7.49788 20.2643 -6.92785 0.102081 -4.68832 +9240 6 36.344 38.7219 4.42923 6.60518 -8.27287 -3.54737 +9241 4 36.8681 39.515 4.62823 -9.591 -1.38231 4.53716 +9242 4 35.4251 38.8858 4.67742 1.90858 4.69501 2.45497 +9243 6 27.7906 17.7903 15.1063 3.75124 -7.8529 -14.6222 +9244 4 27.6041 16.8818 14.7764 0.112743 20.8749 5.00331 +9245 4 27.89 17.7299 16.0573 -1.67078 -3.69001 6.73869 +9246 6 18.0934 3.7697 37.3166 -37.4896 -7.94699 -19.9181 +9247 4 18.6099 3.0373 36.9676 7.8944 1.98274 4.30106 +9248 4 18.6508 4.23334 37.9126 25.9725 10.5984 22.5053 +9249 6 7.70643 11.5866 6.5218 3.89219 -35.3855 26.5153 +9250 4 7.81247 12.3986 6.99593 -0.830342 19.7116 4.35361 +9251 4 7.69429 11.7375 5.59555 -1.18048 8.56411 -33.1609 +9252 6 31.493 14.3493 18.0362 -8.33789 -14.4781 24.6772 +9253 4 32.1359 14.6991 17.4236 11.1505 2.18599 -11.6706 +9254 4 31.9992 13.8221 18.6877 -1.72215 8.99473 -5.41338 +9255 6 50.3257 30.4119 8.91981 13.6638 2.66477 0.921327 +9256 4 49.6699 30.7962 8.33415 -6.09837 5.9585 -1.44957 +9257 4 50.0726 29.5063 9.09532 -3.6785 -2.74239 1.52637 +9258 6 42.1666 10.1001 12.7665 27.8846 0.568566 -7.78474 +9259 4 41.2574 9.89168 12.6212 -25.0269 -7.71108 -1.23548 +9260 4 42.2044 10.927 13.2385 -4.76175 6.29789 8.61568 +9261 6 37.7726 3.10257 32.5651 17.7286 -33.908 -11.3576 +9262 4 38.1655 3.96622 32.6549 -5.80606 19.6252 0.391082 +9263 4 36.8286 3.11418 32.7073 -14.5698 15.7581 5.48125 +9264 6 35.7529 13.1025 19.269 15.6222 -22.7979 5.95892 +9265 4 36.108 13.8438 19.7616 3.89933 6.86159 4.70877 +9266 4 36.3275 12.3403 19.5267 -16.9537 12.3267 -5.61016 +9267 6 45.5307 4.12701 21.4866 3.53751 -14.4086 10.8893 +9268 4 45.552 4.15257 20.5178 1.20389 1.85135 1.62688 +9269 4 45.7304 3.20168 21.7391 -1.66454 15.9633 -13.005 +9270 6 16.8818 1.84763 31.4809 -38.7514 34.7723 -17.791 +9271 4 16.1373 2.3559 31.0688 16.7124 -32.2776 -3.52377 +9272 4 16.9707 2.38347 32.2636 22.4894 -8.71684 18.7287 +9273 6 14.088 4.88632 23.5804 12.6338 -46.5447 -4.7054 +9274 4 13.8705 5.7909 23.7155 -14.7558 31.001 11.1078 +9275 4 13.7332 4.31383 24.2952 -4.17517 18.1368 -8.36436 +9276 6 38.3179 33.7515 12.3711 -25.6361 -5.15185 -28.4625 +9277 4 38.1256 32.9508 11.8227 6.04426 17.9062 13.2724 +9278 4 39.1779 33.654 12.756 21.0695 -5.21903 12.1581 +9279 6 35.6902 3.04562 37.6746 -3.39904 8.35156 -7.25132 +9280 4 35.0929 2.54933 38.2324 -5.1037 -10.0227 3.00486 +9281 4 35.8394 3.86187 38.1597 5.81883 9.20211 1.39187 +9282 6 31.3375 37.3986 35.3773 -3.71028 -11.6357 31.0668 +9283 4 32.2621 37.6229 35.4422 12.7398 8.80293 9.59752 +9284 4 31.1956 37.5429 34.4696 -8.56261 0.879722 -41.7472 +9285 6 52.0699 11.7425 14.0188 13.7235 -2.71131 -30.9774 +9286 4 51.8967 11.0942 13.2788 12.7756 18.36 20.3091 +9287 4 52.777 12.3878 13.7226 -29.9657 -23.6346 9.26958 +9288 6 26.3494 3.44143 41.0133 25.155 -37.875 16.6614 +9289 4 25.5593 3.94137 41.1232 -17.1598 23.2709 -17.7277 +9290 4 26.8278 3.58917 40.1822 -8.59815 12.7626 -4.44352 +9291 6 24.371 34.9599 11.1571 26.4033 32.6711 -2.50587 +9292 4 24.3639 34.5741 12.011 0.42503 -6.32387 38.1824 +9293 4 23.9976 34.2869 10.6415 -25.866 -31.4028 -29.8537 +9294 6 32.0031 7.59722 31.2247 -0.72006 7.33901 18.8157 +9295 4 32.1508 7.36357 30.327 0.345644 0.817488 -27.7554 +9296 4 31.6126 8.48818 31.2118 -2.13527 -8.40442 2.30992 +9297 6 28.7291 2.6069 0.424694 -24.9548 -1.7826 -18.2237 +9298 4 29.2265 2.34055 41.548 2.55638 3.32464 9.52498 +9299 4 27.7798 2.59721 0.142899 25.7986 3.33204 9.63582 +9300 6 42.1267 19.2107 9.86358 19.9254 -1.00598 31.807 +9301 4 42.7282 19.2504 10.675 -28.0191 -3.63038 -32.4782 +9302 4 41.4654 18.506 9.99331 2.41107 5.70909 -2.24499 +9303 6 33.0117 27.0899 8.33041 6.96541 -9.8522 -22.9567 +9304 4 33.8754 26.9804 7.88875 -4.89246 2.6856 6.68054 +9305 4 33.1889 27.2976 9.23992 7.88062 7.04275 14.0068 +9306 6 4.17016 8.31297 19.162 0.312608 -23.727 -31.8356 +9307 4 4.57057 7.90515 18.3575 7.98956 13.418 22.158 +9308 4 3.24181 8.25888 18.9046 -6.31749 7.79174 9.16769 +9309 6 20.797 29.1851 37.0682 -78.8245 -16.0462 -5.4556 +9310 4 20.936 28.2326 36.9784 16.4861 -0.723813 3.66436 +9311 4 21.5674 29.6886 37.0761 54.0195 18.5923 4.39527 +9312 6 13.113 4.99943 10.9253 0.843453 12.9862 -7.21248 +9313 4 13.3812 5.91092 11.1622 0.48683 -16.0572 0.936043 +9314 4 12.7752 5.03128 10.0238 -4.21215 6.55392 -0.64752 +9315 6 37.5015 18.1018 32.5195 21.2703 25.6519 14.9603 +9316 4 38.1786 18.7738 32.2234 -25.3038 -17.5123 8.13315 +9317 4 37.1867 18.4103 33.3985 6.70568 -0.056708 -13.7279 +9318 6 17.7491 33.2689 30.7387 4.64458 14.8517 -20.1826 +9319 4 17.8421 33.9996 30.1068 1.39741 -2.79987 6.34018 +9320 4 18.5541 33.2627 31.2599 6.50121 5.74528 2.59283 +9321 6 23.1871 32.777 9.90494 7.13269 10.4795 -4.3903 +9322 4 23.4604 31.94 10.2921 1.41378 -5.3263 0.807867 +9323 4 22.2339 32.7251 9.74224 0.938735 -0.283076 -0.953242 +9324 6 14.8916 9.36878 34.2544 -3.17606 -9.25219 -4.09189 +9325 4 15.4257 8.57154 34.1751 4.23415 -4.52565 -0.814207 +9326 4 15.1936 9.94604 33.5417 3.33837 13.7034 4.88209 +9327 6 31.123 39.3556 38.5725 10.4581 -15.7875 9.507 +9328 4 31.6408 38.6334 39.0195 -17.0405 19.4438 -10.5616 +9329 4 30.3963 38.9123 38.1137 2.26745 0.847431 0.999129 +9330 6 5.28935 34.441 28.2777 -1.85934 -10.7383 -20.8922 +9331 4 5.27738 35.3973 28.3959 -1.64374 -0.931958 4.82044 +9332 4 5.15855 34.3195 27.3212 3.56171 0.206479 13.9304 +9333 6 30.3161 21.6889 14.1169 -2.08187 28.5408 26.4102 +9334 4 30.4824 20.7856 14.3415 3.20532 -20.0191 -7.60805 +9335 4 30.3589 21.8902 13.1869 1.55029 -10.1196 -17.5522 +9336 6 23.85 39.0046 28.2977 69.4329 26.2515 4.57453 +9337 4 23.9916 39.6084 27.5499 -13.57 2.08121 2.63988 +9338 4 23.036 38.5875 28.2612 -60.5143 -23.8938 -11.8576 +9339 6 9.59742 13.5396 16.4589 33.261 19.9292 -8.86772 +9340 4 8.78625 13.0496 16.3926 -14.9619 -4.96746 -5.567 +9341 4 9.78335 13.9533 15.5888 -9.09133 -14.4247 9.50074 +9342 6 25.9705 6.17968 15.7985 42.799 -23.1477 28.9675 +9343 4 26.019 6.01901 14.8637 -2.75181 4.35539 -17.3872 +9344 4 26.7603 5.64791 16.135 -36.9143 25.7793 -10.0513 +9345 6 15.9952 33.6108 22.5498 -1.32684 21.179 0.174096 +9346 4 16.0845 34.132 21.7265 -5.08009 -17.3545 9.33233 +9347 4 16.0452 32.6693 22.2946 2.44519 21.8582 -2.86748 +9348 6 40.6954 13.5457 12.1293 -5.68603 3.79069 10.9638 +9349 4 40.3939 13.0592 11.3555 -1.07855 -14.0058 -3.54454 +9350 4 41.0539 12.9031 12.7626 -3.06611 3.62129 -5.67307 +9351 6 35.5822 40.2773 31.6862 -1.2862 -13.706 14.6905 +9352 4 36.0451 40.9783 31.2154 -1.32327 -4.34646 -14.1397 +9353 4 35.653 39.3915 31.2603 0.648621 22.1552 -3.29488 +9354 6 19.3539 17.5757 17.8527 24.8545 64.4629 -5.36553 +9355 4 19.9703 18.4106 17.9379 -31.776 -45.1138 0.798127 +9356 4 18.7059 17.8424 17.1823 2.41282 -7.28307 3.58563 +9357 6 7.95249 28.0742 10.7793 26.3782 25.043 4.49745 +9358 4 8.50313 28.8396 11.0908 -15.1612 -19.5627 1.83511 +9359 4 7.20779 28.4792 10.322 -5.34026 -2.34355 -4.06419 +9360 6 32.1473 39.5951 16.6478 -17.9563 1.55165 -8.91142 +9361 4 31.6569 40.3908 16.3404 14.2892 -12.9666 6.03874 +9362 4 31.5266 38.8716 16.4637 6.06753 4.48602 8.64925 +9363 6 35.7883 2.63292 18.1275 9.48574 -34.9606 14.0071 +9364 4 34.8666 2.32593 18.1793 13.7366 6.70894 -2.41967 +9365 4 35.7792 3.51083 17.8116 -6.62646 29.9084 -15.3578 +9366 6 14.9404 39.9496 36.887 -3.95865 -34.2615 35.0372 +9367 4 15.4649 39.4425 36.2826 11.0028 -6.45738 -16.6057 +9368 4 15.0284 40.8419 36.6608 5.56286 51.7396 -15.8162 +9369 6 18.3052 32.4025 11.469 7.68428 8.43447 19.219 +9370 4 18.6311 32.5236 12.4045 -8.3236 -1.07971 -30.5152 +9371 4 17.8613 33.2392 11.223 7.02035 -14.738 0.639166 +9372 6 14.6021 10.381 5.00501 12.904 -5.64335 9.41677 +9373 4 13.6938 10.4305 4.69945 -10.3065 0.63937 1.1744 +9374 4 14.613 10.0418 5.92181 -1.23128 6.20644 -15.3767 +9375 6 2.02771 14.3355 39.1727 -5.84559 30.0988 4.34298 +9376 4 2.70173 15.0418 39.0898 -4.78946 -14.8923 5.30178 +9377 4 1.28797 14.7602 39.6738 10.0694 -17.377 -15.1558 +9378 6 7.58332 14.1556 32.4652 3.8824 27.7869 10.7592 +9379 4 6.9433 13.665 32.9756 -4.43494 -6.18284 1.69377 +9380 4 7.54129 15.0698 32.8492 6.23928 -24.1467 -15.6449 +9381 6 6.15722 23.1341 37.6504 -34.5618 -50.1938 -2.0692 +9382 4 6.56488 23.96 37.7745 13.4151 41.4847 -0.267706 +9383 4 5.38195 23.2242 37.0516 20.9526 5.02196 8.70483 +9384 6 37.2952 22.537 4.44472 51.3933 75.9823 3.75371 +9385 4 36.5074 22.1342 4.18978 -47.7056 -22.8011 -17.3868 +9386 4 37.221 23.5361 4.21623 -3.53185 -51.7458 12.1203 +9387 6 47.1368 31.0168 5.89375 -14.3926 17.1884 -69.1718 +9388 4 46.9718 30.7968 6.77028 -10.6218 -7.91998 56.0799 +9389 4 46.2684 31.351 5.53353 23.0456 -16.9797 4.17914 +9390 6 54.8109 25.5937 34.9376 16.0179 27.3393 -6.0446 +9391 4 54.0726 25.4665 35.5517 -1.08617 7.29827 -2.61058 +9392 4 0.161491 26.54 35.0366 -21.9365 -36.0956 3.57937 +9393 6 37.1499 2.07739 4.80452 -1.94348 22.0087 -45.3652 +9394 4 36.668 2.89852 4.54683 5.06511 -19.4283 11.9563 +9395 4 37.1062 1.96831 5.73813 -4.74438 -1.19387 27.2393 +9396 6 22.5142 28.609 8.91066 14.7838 -0.767913 33.3492 +9397 4 22.9803 28.3541 9.73828 -15.565 12.7605 -7.61321 +9398 4 22.8168 27.9481 8.31925 3.93055 -13.9923 -25.0246 +9399 6 8.64284 27.1533 24.5627 -30.3364 66.7798 9.61681 +9400 4 7.68564 27.0552 24.6389 4.16714 -15.7471 -5.05425 +9401 4 9.10482 26.3676 24.4825 22.9633 -64.4218 -6.53839 +9402 6 1.14841 23.7276 2.43845 3.37143 2.75553 -28.3576 +9403 4 1.24451 23.8913 1.47114 -2.40676 3.6179 20.3541 +9404 4 0.297784 23.2877 2.48462 -2.13531 -2.42607 6.29474 +9405 6 54.3749 30.2279 27.0351 -1.87188 5.01086 -25.6864 +9406 4 54.247 29.4439 26.4851 0.283672 1.58093 2.67322 +9407 4 54.589 30.9178 26.3677 -1.31459 -2.18642 16.2549 +9408 6 0.382292 8.43516 23.9819 16.8945 -11.9539 9.7221 +9409 4 1.32445 8.60369 24.1565 -2.20413 -11.2301 -8.89161 +9410 4 54.9553 8.73001 24.7921 -9.77823 11.7559 2.768 +9411 6 16.9131 28.5848 33.3683 -2.23593 -25.3201 -21.0962 +9412 4 17.3654 28.7863 34.1955 9.02781 -2.88055 -0.915496 +9413 4 17.3951 27.8627 32.8656 -13.2947 27.9561 26.4245 +9414 6 33.6945 30.8881 0.140848 11.5734 5.16226 7.65985 +9415 4 34.5903 30.4955 0.196618 -6.50407 7.83028 -3.90982 +9416 4 33.2725 30.4522 41.313 0.902851 -8.5209 -4.03004 +9417 6 16.2572 21.5133 34.1618 -1.32279 -12.2579 -0.0768877 +9418 4 15.8666 20.7686 33.6578 14.5936 10.7995 5.0381 +9419 4 16.7742 21.1109 34.8905 -13.5083 8.43335 -11.1581 +9420 6 0.208862 17.804 35.7536 -14.601 -29.9007 -2.72034 +9421 4 54.2286 17.807 35.5323 33.4083 9.0609 14.8615 +9422 4 0.362977 16.9429 36.1939 -0.60553 13.4006 -6.21859 +9423 6 16.8205 12.2987 0.018055 22.2965 10.2312 29.8095 +9424 4 17.2696 12.8062 0.753963 -11.4311 -8.71934 -28.0399 +9425 4 16.617 11.4478 0.422257 -11.1364 1.3302 -4.58262 +9426 6 8.24969 9.53941 36.253 -15.0171 13.8578 -6.15226 +9427 4 7.92627 8.96163 36.9484 -10.0154 -4.61382 -0.313479 +9428 4 7.46687 9.9886 35.83 14.4541 -3.15884 14.1629 +9429 6 48.5699 26.7153 39.8372 -6.05787 -6.72914 15.0837 +9430 4 48.3449 26.8926 38.9385 -16.4424 3.29077 -18.6566 +9431 4 49.4571 27.0352 39.8842 23.4859 3.73228 5.76721 +9432 6 35.4844 1.07048 23.1169 11.4549 30.8088 37.1655 +9433 4 36.0158 1.76714 22.6808 -9.17201 -14.7916 0.90361 +9434 4 35.6328 1.27141 24.1103 0.373025 -19.0496 -44.6811 +9435 6 20.2784 30.6315 19.3752 23.9103 -21.6662 15.3888 +9436 4 20.3116 31.0532 20.259 -5.42732 -3.95571 -8.57186 +9437 4 20.9344 29.8759 19.4191 -22.0709 25.9102 -5.54449 +9438 6 44.3706 15.9499 1.58551 5.68582 14.4456 12.9619 +9439 4 44.3685 15.5676 2.49167 2.87795 14.7015 -16.764 +9440 4 44.6274 16.9163 1.6094 -6.5628 -31.3198 6.45039 +9441 6 53.8881 34.4681 10.5864 -33.0496 11.7448 -26.9592 +9442 4 54.422 34.2751 11.3149 32.4161 -9.35278 40.7994 +9443 4 54.2788 35.2396 10.1584 -0.0979649 -6.0993 2.73708 +9444 6 46.1388 32.8516 33.5211 5.22207 -15.0187 3.22626 +9445 4 45.9452 33.6327 33.0044 -1.75723 11.2428 -3.91525 +9446 4 47.0422 32.5752 33.2841 -5.1447 4.42718 0.252344 +9447 6 42.1248 21.9061 24.225 29.3467 -8.59285 14.1471 +9448 4 43.0897 21.6191 24.2618 -39.2895 4.06832 7.69751 +9449 4 41.7308 21.6944 25.1042 13.707 1.91177 -18.5137 +9450 6 8.13464 3.90485 11.6471 19.3767 -1.70453 -18.8264 +9451 4 7.33962 4.19894 12.0861 -8.05938 -6.79837 10.6821 +9452 4 8.35918 3.01511 11.9412 -4.68297 1.80025 9.46807 +9453 6 19.6422 41.6776 9.83213 -10.6455 12.1827 13.5714 +9454 4 18.8651 41.1405 9.66265 4.99962 -3.76564 -7.41899 +9455 4 19.3487 0.264237 10.6212 9.02518 -11.5641 -14.6522 +9456 6 42.3073 8.42404 31.6799 28.9247 6.2763 -10.2166 +9457 4 41.4386 8.38933 32.0551 -18.7028 2.48038 0.978172 +9458 4 42.5266 9.37939 31.5704 -3.99861 -19.3235 1.7837 +9459 6 26.9144 16.155 25.3557 3.37886 4.46922 -29.1574 +9460 4 26.8932 15.8089 24.4276 -4.09623 14.1183 21.5023 +9461 4 26.5944 15.4425 25.8888 -2.2842 -17.5105 15.3426 +9462 6 48.2339 6.48607 12.6213 -2.32796 -4.32122 -9.13051 +9463 4 48.9884 6.29985 12.0375 -6.36801 1.93824 2.64233 +9464 4 47.4521 6.15437 12.1363 8.14441 0.739204 7.03502 +9465 6 53.4551 41.5313 30.6545 -6.55363 -20.9747 -16.7061 +9466 4 53.9707 41.8328 29.895 1.38615 3.54438 2.31965 +9467 4 53.5938 0.199493 31.3858 11.9182 14.0856 15.8016 +9468 6 47.0766 22.4304 31.8083 3.49024 11.2606 -9.33253 +9469 4 47.8957 22.458 31.249 -27.0486 7.80914 13.6686 +9470 4 46.5597 23.2507 31.6033 14.3992 -20.3875 6.89099 +9471 6 19.5103 5.43818 15.252 80.4346 7.77941 -36.259 +9472 4 19.9845 4.58151 15.2093 -6.94904 10.3389 3.32724 +9473 4 18.6939 5.26573 15.6196 -64.0069 -9.45641 27.6942 +9474 6 14.6723 30.2358 33.3977 29.3194 14.0021 -15.573 +9475 4 15.2147 30.9127 32.9173 -16.9191 -15.4944 5.99358 +9476 4 15.2716 29.4658 33.3729 -9.39086 7.05787 2.01807 +9477 6 28.44 24.2314 10.4028 3.15123 -12.4056 -9.54268 +9478 4 29.226 24.4262 10.8786 32.4584 2.85658 2.79411 +9479 4 27.8296 24.5485 11.0342 -36.3144 6.15546 12.0187 +9480 6 5.27118 14.4387 24.4945 35.1445 25.2092 -0.0633509 +9481 4 4.43594 14.1516 24.7736 -48.8682 -19.2375 4.52664 +9482 4 5.4685 14.0235 23.6561 -3.04719 -11.4521 -9.99341 +9483 6 26.3524 19.2908 19.1818 20.1263 -20.0506 -24.4735 +9484 4 26.6388 20.1349 19.5116 -1.98461 18.5008 5.62334 +9485 4 27.0961 18.9592 18.5977 -26.1102 9.18548 27.2368 +9486 6 28.5758 7.44193 13.1857 16.8206 36.5977 2.40675 +9487 4 28.4276 6.5743 12.8854 -8.83608 -34.241 -6.14436 +9488 4 29.1296 7.84613 12.4994 -7.23682 2.38597 3.89632 +9489 6 5.36882 27.1473 37.046 11.8823 -4.88323 19.1587 +9490 4 6.08575 26.9595 37.7076 -19.1456 -1.45009 -21.6041 +9491 4 5.36685 28.0942 36.8598 5.86896 -0.355799 -4.60773 +9492 6 53.1378 13.4025 16.0996 34.2435 -3.86055 5.06914 +9493 4 54.0829 13.0966 15.9504 -32.0077 5.91706 2.7318 +9494 4 52.5847 12.6783 16.4422 5.4814 -0.344951 -11.4066 +9495 6 45.452 1.01889 24.6154 3.31322 11.7394 9.54943 +9496 4 44.8157 0.989703 23.8982 -3.33354 -4.25493 -1.52857 +9497 4 44.9019 0.844105 25.4008 9.82267 -2.51687 -6.81685 +9498 6 50.1641 2.37547 13.9256 -5.79196 7.9049 4.59273 +9499 4 50.7992 2.78767 13.3238 -3.84891 -0.754592 0.637936 +9500 4 49.4746 3.0334 14.0873 2.34893 4.7321 -2.13859 +9501 6 19.5803 31.0161 39.1628 -18.0613 -25.9328 -11.5794 +9502 4 19.7424 30.2951 38.4816 -0.347779 24.7736 22.083 +9503 4 18.6224 30.9377 39.4182 28.2801 4.19594 -11.375 +9504 6 19.2561 14.7051 10.8744 35.9018 -50.5273 5.13524 +9505 4 20.0412 14.097 10.5737 -45.0165 49.548 5.48727 +9506 4 18.7602 14.0269 11.3662 -4.16951 16.5755 -2.6658 +9507 6 4.45594 39.5485 20.1375 -7.26247 21.8372 28.3356 +9508 4 3.95576 40.4005 20.2782 15.6699 -22.2203 -5.74536 +9509 4 4.87483 39.3065 21.0019 -15.4768 4.14169 -24.4646 +9510 6 29.0152 13.3442 23.91 8.01267 35.4951 15.4816 +9511 4 28.7225 12.4574 23.7464 -4.82052 -12.6612 5.31893 +9512 4 28.8407 13.5397 24.8723 9.679 -4.85246 -32.6651 +9513 6 17.068 2.76349 17.6602 17.5731 -10.7754 -19.6116 +9514 4 16.9152 3.43747 16.9733 0.569879 -2.90947 3.06519 +9515 4 17.8166 2.20316 17.3149 -21.6663 12.1671 7.12297 +9516 6 43.4725 18.0406 17.7144 -1.44781 -24.3706 15.3127 +9517 4 43.4291 17.0524 17.7495 6.1749 24.1268 -14.107 +9518 4 43.576 18.2305 18.6573 0.474252 7.4982 -2.94392 +9519 6 25.7765 40.7491 1.25834 -5.13784 -8.67992 -41.8469 +9520 4 26.3241 41.1434 1.92597 2.9618 17.1891 5.50682 +9521 4 25.7331 41.3641 0.469204 -4.81559 -13.5206 29.0343 +9522 6 0.465549 22.8917 6.22214 -2.55797 -7.94984 -3.9446 +9523 4 0.971697 22.1453 5.8424 -8.20264 3.34524 4.91565 +9524 4 1.09943 23.372 6.75946 4.60597 5.6548 -4.31438 +9525 6 26.241 35.011 18.6432 -1.36099 17.7753 -9.20742 +9526 4 25.9471 35.9461 18.6768 6.76043 -15.7179 -8.96745 +9527 4 25.6107 34.5957 19.2286 4.79325 -10.2415 3.05652 +9528 6 16.134 31.8742 7.55305 63.3701 -24.5537 -22.1036 +9529 4 16.96 31.3344 7.22221 -43.8871 18.402 28.1533 +9530 4 16.2567 32.6659 7.02685 -6.92396 6.43503 -6.66113 +9531 6 22.9365 16.8424 28.5556 -11.8911 28.7995 -6.03551 +9532 4 23.1131 16.1224 27.957 -2.92592 -13.6094 -7.1053 +9533 4 22.1672 17.3806 28.2048 22.5292 -24.3034 15.5849 +9534 6 48.8154 29.3426 32.1508 17.6607 -5.63259 25.101 +9535 4 47.9338 29.1776 31.8283 -15.752 -0.354552 -3.67809 +9536 4 48.876 28.9209 33.0523 -3.3832 13.4569 -22.7771 +9537 6 13.1275 24.861 5.55911 -24.9858 12.0714 -24.023 +9538 4 12.9095 24.1076 4.98414 3.68764 2.77663 3.09454 +9539 4 12.4428 25.5491 5.3163 19.4298 -17.0083 16.84 +9540 6 10.97 20.7168 15.838 25.2219 -21.2413 -18.4662 +9541 4 10.9273 20.4774 14.8836 -9.78471 10.8905 20.232 +9542 4 11.8407 20.3068 16.0784 -25.4832 11.5027 -0.03881 +9543 6 13.8668 18.3675 6.9377 -17.1805 34.1284 -15.5183 +9544 4 13.9861 19.3268 7.07801 0.95534 -8.68107 -9.41428 +9545 4 14.2312 17.9937 7.71618 14.696 -22.4056 21.3209 +9546 6 13.8328 12.9436 30.6366 23.8936 8.4875 1.93436 +9547 4 14.0561 12.5213 29.7889 -15.7862 -10.4805 9.2002 +9548 4 13.0857 12.5134 31.0734 -5.46762 -5.09599 -12.1481 +9549 6 17.1276 6.33232 31.2677 66.6528 76.8842 26.6004 +9550 4 16.7194 7.19542 31.0916 2.25558 -4.54354 -1.53399 +9551 4 16.4872 5.75051 31.0533 -74.7845 -70.3194 -26.0669 +9552 6 7.63688 23.4278 20.549 2.87884 3.81634 -6.68902 +9553 4 7.34623 23.1229 19.6666 2.94756 -0.449201 10.6329 +9554 4 8.04096 24.3016 20.3852 -3.87648 -11.4978 -1.95405 +9555 6 15.5875 36.6622 25.6317 44.8659 35.0544 -6.16252 +9556 4 16.5723 36.6215 25.7443 -25.3852 -14.6967 7.558 +9557 4 15.5456 37.5452 25.2115 -8.92727 -11.7797 -1.50769 +9558 6 0.738994 10.4213 22.1809 -27.1543 -36.2471 -13.1925 +9559 4 0.031346 10.3136 21.4752 22.4259 7.4169 21.1377 +9560 4 0.614162 9.62536 22.7539 0.837437 23.266 -16.3015 +9561 6 33.4753 17.3986 33.5966 50.0322 34.9653 -25.691 +9562 4 33.729 18.3684 33.3861 -23.79 -42.9591 12.1009 +9563 4 34.1104 16.8695 33.0603 -9.99519 5.32569 13.787 +9564 6 21.6594 19.0069 20.7632 22.9673 -17.6764 -6.78691 +9565 4 22.3468 19.6741 20.9606 -3.94962 -13.1079 -1.95693 +9566 4 22.1476 18.14 20.6003 -16.6978 33.0759 6.74927 +9567 6 41.7633 20.003 16.8748 -11.326 -1.31128 -8.84591 +9568 4 42.2034 19.1563 16.9874 6.48398 -7.2756 0.328325 +9569 4 41.4682 20.0367 15.9399 8.87316 5.12137 10.7952 +9570 6 12.0358 14.9766 17.6999 -26.21 -7.2152 -26.0517 +9571 4 11.2991 14.5498 17.1995 11.2858 13.8526 14.1879 +9572 4 12.4764 14.2447 18.105 9.10187 -13.3837 13.9354 +9573 6 23.0147 11.4211 40.7142 -19.9953 11.3897 74.5259 +9574 4 22.9359 12.2968 41.1901 4.60696 -23.5555 -21.1396 +9575 4 23.3157 11.5565 39.857 19.7433 14.0142 -51.5111 +9576 6 21.0056 28.3023 24.5803 -69.1041 85.2373 -40.9106 +9577 4 20.265 28.1264 25.1705 5.37048 -3.26467 3.49678 +9578 4 21.6928 27.7549 24.7451 59.1792 -66.0576 27.8401 +9579 6 19.39 13.7159 31.9239 29.4118 -13.0288 15.1298 +9580 4 18.7661 13.9847 31.2678 -13.3276 3.02657 -9.68553 +9581 4 18.8827 13.5849 32.728 -3.24577 4.6437 7.00982 +9582 6 21.5915 2.84466 24.7134 0.208747 24.5944 -29.04 +9583 4 21.6872 3.18692 23.7998 -4.92058 -5.74628 13.5023 +9584 4 22.4885 2.58061 24.905 3.18231 -12.543 15.1704 +9585 6 11.3458 29.9955 18.8336 12.03 22.8495 18.6886 +9586 4 10.5716 30.5896 18.8018 6.29595 -15.7791 -4.99952 +9587 4 11.9743 30.476 19.4324 -17.0963 -23.9187 -22.0967 +9588 6 14.6495 22.3648 8.3568 42.8177 1.00499 7.23029 +9589 4 14.0031 23.0587 8.53935 2.83958 6.20927 5.13977 +9590 4 15.5993 22.7606 8.33857 -60.0645 -13.0658 0.526795 +9591 6 43.9468 23.6541 17.2812 -2.43742 26.8438 -12.7514 +9592 4 44.7651 23.2701 16.9945 19.1668 -3.91001 -9.18188 +9593 4 43.5028 22.9 17.6346 -11.2125 -8.13016 15.2757 +9594 6 28.0047 25.4978 27.5091 9.49546 -35.4414 -7.32855 +9595 4 27.536 26.3032 27.53 -22.6173 33.7003 2.08289 +9596 4 28.9082 25.7508 27.3241 10.2254 5.98924 0.98151 +9597 6 19.1021 26.8113 33.1456 6.96794 1.44941 -44.6281 +9598 4 19.0009 26.3889 32.2316 6.61058 22.4795 36.193 +9599 4 19.4537 27.7357 32.9996 -8.5054 -25.835 6.12407 +9600 6 6.37601 19.3499 5.67113 -3.07724 -15.511 8.20386 +9601 4 6.68786 20.0294 5.07731 7.18653 8.65774 -7.7972 +9602 4 5.56195 19.7092 6.03854 -2.87224 2.62267 4.46635 +9603 6 37.49 28.403 9.68405 -10.2736 -31.6176 -26.4717 +9604 4 37.8518 27.9475 10.4351 5.1765 10.0485 19.5132 +9605 4 37.3493 27.6251 9.09625 -2.69325 25.3221 7.01666 +9606 6 17.6998 27.0953 11.7898 -36.7906 -34.4972 13.5582 +9607 4 17.0141 26.488 11.3694 25.6316 27.0728 3.78529 +9608 4 17.4298 27.07 12.7376 6.94557 14.4563 -18.9236 +9609 6 12.8888 1.93962 24.1529 -50.3802 38.9184 -15.728 +9610 4 12.0235 2.45928 24.1313 32.0413 -19.6529 -17.3906 +9611 4 12.9222 1.7892 25.0724 13.055 -19.4335 33.1456 +9612 6 27.8476 37.1183 33.3015 17.2618 -5.56645 -20.6455 +9613 4 27.8725 37.7306 32.5366 -3.66202 -8.07766 15.1749 +9614 4 28.4268 36.3488 33.0405 -13.8477 22.6944 8.61763 +9615 6 18.6736 12.3707 6.31908 6.91225 -31.4632 27.4828 +9616 4 18.6995 11.385 6.25383 -9.67628 20.7874 -2.26223 +9617 4 18.5836 12.6888 5.4344 -4.12511 6.2973 -26.1687 +9618 6 10.1784 29.305 24.7735 -9.10204 -23.9111 21.4033 +9619 4 10.6991 28.9855 25.5395 2.35147 16.2142 -6.30056 +9620 4 9.48939 28.598 24.7147 15.6456 22.7499 -9.47694 +9621 6 7.25796 3.28933 16.2737 -3.06701 21.6066 -7.53298 +9622 4 7.8017 4.02386 16.6541 -5.18893 -18.6288 5.77884 +9623 4 6.83195 2.7267 16.9458 19.6595 6.39335 -0.783342 +9624 6 32.1965 37.5589 1.11244 17.7564 -13.393 -49.4834 +9625 4 31.8113 36.9118 1.6863 -14.8068 -2.94474 23.9511 +9626 4 32.3136 38.4192 1.49585 -8.3749 16.0852 25.1081 +9627 6 10.4319 10.1504 6.4166 -7.63199 8.14139 10.6713 +9628 4 9.50403 10.3698 6.52583 -9.38347 6.87647 -8.77798 +9629 4 10.8186 10.5343 7.22249 5.92406 -9.68277 -8.25616 +9630 6 16.1813 23.2506 37.3799 25.1097 11.6639 -4.85114 +9631 4 16.5396 23.4181 38.2693 -7.5274 5.30939 -3.10176 +9632 4 16.7237 23.8262 36.781 -18.6662 -9.83464 11.0165 +9633 6 24.0859 14.3313 36.5421 -9.86516 7.30801 -0.382215 +9634 4 25.0278 14.1902 36.5644 12.4097 -8.07045 3.76472 +9635 4 23.7255 13.9571 37.3615 2.98939 6.5027 1.55174 +9636 6 27.4763 18.5532 28.7891 -13.5271 -4.91773 7.22809 +9637 4 27.279 18.1935 29.6763 -0.617381 3.48163 -16.8994 +9638 4 26.6639 18.4733 28.2428 3.34183 3.33207 10.806 +9639 6 51.5601 10.4909 1.56577 -57.9967 -14.5533 -18.7957 +9640 4 50.8004 9.99697 1.98849 19.2905 21.9947 -18.6033 +9641 4 52.233 10.462 2.20044 35.6887 -2.31897 35.1783 +9642 6 31.1159 39.6224 27.5035 10.1927 26.9633 6.19817 +9643 4 30.6636 39.3812 28.2975 -12.6206 -22.2416 8.82104 +9644 4 31.2642 40.5609 27.7597 6.49383 -23.2522 -24.0775 +9645 6 6.91312 35.9708 14.3252 -31.0555 -15.8542 22.3873 +9646 4 7.60399 36.2341 13.7609 26.7748 16.1612 -20.4248 +9647 4 7.14109 35.0698 14.5861 -2.88708 -0.858877 1.78829 +9648 6 45.5543 7.568 29.1737 -25.5302 -4.16762 -2.13202 +9649 4 44.8976 7.53234 28.4293 19.2773 0.699039 20.3251 +9650 4 45.0852 7.16669 29.9393 6.23602 2.26061 -10.7804 +9651 6 31.3622 20.562 31.6184 9.65463 4.63597 0.319717 +9652 4 31.8498 21.4034 31.7895 1.14978 -23.5084 -11.6884 +9653 4 31.8627 19.9392 31.0494 0.180852 16.2895 10.8054 +9654 6 43.0328 31.1512 10.3804 -22.1718 15.2565 33.5805 +9655 4 42.075 30.8844 10.4741 26.7443 4.92622 -3.29861 +9656 4 43.2631 31.5811 11.2548 -4.68507 -19.1463 -31.4268 +9657 6 50.935 25.5526 12.6381 -53.0362 -11.2381 37.5759 +9658 4 50.8444 26.3707 12.1889 6.26198 32.0523 -21.5557 +9659 4 51.7606 25.1556 12.4927 46.8244 -9.35474 -8.90879 +9660 6 29.329 2.97736 3.64421 22.5456 -43.1143 -6.52899 +9661 4 29.5843 3.84773 3.82541 15.3974 46.6652 11.4603 +9662 4 28.3975 3.01514 3.57252 -35.3193 1.84796 -10.7817 +9663 6 53.9306 32.0952 20.3602 -26.044 3.42844 6.98601 +9664 4 54.8587 32.2554 20.2589 13.6369 -3.90514 -8.57062 +9665 4 53.586 31.7345 19.5218 3.48091 2.50952 8.05406 +9666 6 41.7156 29.5544 6.48768 19.5894 27.0766 -19.1548 +9667 4 40.8143 29.536 6.19581 -21.1406 0.0261655 0.681639 +9668 4 42.121 30.2839 5.93213 -7.9284 -21.0777 21.5612 +9669 6 37.8354 24.5725 39.3073 -0.786614 -2.83003 -8.48557 +9670 4 37.3057 24.1981 38.5867 -0.305281 2.91934 11.1175 +9671 4 37.4479 24.2715 40.1417 -1.64355 1.86967 -5.36783 +9672 6 46.558 27.5785 23.289 -39.9634 -64.6481 11.0379 +9673 4 46.4646 27.3918 24.2576 6.74558 16.0433 -18.2165 +9674 4 45.9199 26.8188 22.9475 37.5572 46.869 6.09964 +9675 6 9.22773 27.2022 8.33468 -36.26 12.7871 28.7267 +9676 4 8.91275 27.6129 9.1801 5.62558 -9.89589 -23.2096 +9677 4 10.1414 27.0456 8.46037 35.2783 -3.07459 2.5747 +9678 6 36.0491 34.1608 13.9867 7.26402 -14.0442 8.68546 +9679 4 35.9913 33.1738 14.0461 -7.39622 22.1346 -4.41017 +9680 4 36.7548 34.3393 13.3524 -0.0889916 -4.95725 -2.25698 +9681 6 51.6742 14.4867 12.321 25.1613 25.5512 -24.4042 +9682 4 52.0989 14.4284 11.4335 -6.19684 -3.38259 22.4379 +9683 4 51.9807 15.3554 12.6493 -12.3863 -19.4348 1.31199 +9684 6 15.2583 19.6409 32.4144 29.0083 -20.2623 -33.8133 +9685 4 15.2558 19.2688 31.4922 3.04968 7.12699 22.6875 +9686 4 14.3622 19.8256 32.5802 -41.1763 4.86179 8.56209 +9687 6 27.6812 24.6569 38.3606 -19.0318 -31.8029 -32.3422 +9688 4 27.9736 25.1472 39.0974 14.6808 26.4307 29.745 +9689 4 28.3717 24.6185 37.6939 9.13491 6.22605 4.36089 +9690 6 37.5205 9.26898 13.6241 11.458 -4.07639 -2.41324 +9691 4 37.986 8.73412 14.2818 -4.17908 -1.66932 4.91722 +9692 4 37.422 10.1332 14.0472 -5.80925 -1.58022 -1.38856 +9693 6 20.8962 33.2419 26.2614 5.37543 12.855 -2.41316 +9694 4 21.3204 33.4412 27.1125 -5.30181 -3.15861 -4.46659 +9695 4 20.9369 32.3076 26.1263 8.87353 -20.0108 1.20924 +9696 6 6.59104 13.9455 35.2329 -26.8274 -4.60486 4.58094 +9697 4 6.38745 12.9897 35.2457 11.7642 5.99643 -3.17645 +9698 4 7.53507 14.0926 35.2395 12.5421 -8.77428 2.26249 +9699 6 10.0726 7.48467 6.8792 2.12641 6.95589 -11.9404 +9700 4 9.21804 7.15917 6.5645 -4.80657 -1.75614 5.47812 +9701 4 10.1222 8.42177 6.5916 5.16955 -15.159 7.51812 +9702 6 31.1977 5.95154 11.4339 24.7603 28.3677 15.6689 +9703 4 31.4296 6.16733 12.4018 -4.97657 -8.97631 -41.3224 +9704 4 31.9131 6.32779 10.8565 -11.9651 -11.6794 24.5691 +9705 6 12.1328 3.85103 35.2933 -10.0815 -12.0493 27.5499 +9706 4 12.7851 4.21657 34.7189 20.4312 8.87509 -12.0205 +9707 4 12.5123 3.89786 36.1903 -2.36263 6.36147 -16.6701 +9708 6 5.35168 6.07805 27.6549 3.96089 -18.0524 46.6648 +9709 4 5.01336 6.85569 28.0965 2.16186 8.49085 15.9688 +9710 4 5.1377 6.25223 26.7855 -7.5711 11.2001 -66.4514 +9711 6 13.1382 33.574 1.68419 20.6109 34.6607 2.95503 +9712 4 12.5953 33.0967 1.0817 -13.6453 -8.09858 -18.4215 +9713 4 13.3822 34.4502 1.26439 -11.0211 -27.5174 16.1165 +9714 6 44.6427 10.3996 29.0359 8.91116 23.4714 -13.18 +9715 4 44.4953 9.45294 29.0952 0.434286 -4.87704 -7.20081 +9716 4 44.1618 10.7755 28.2587 -0.00111917 -13.6507 16.636 +9717 6 9.15295 24.5944 6.37753 4.35763 15.0755 22.3214 +9718 4 8.87327 24.2546 5.53613 0.42871 5.14079 -20.2862 +9719 4 9.64462 25.4438 6.24707 -3.48643 -17.4971 -5.55606 +9720 6 52.5676 27.2719 21.6547 -2.39965 -30.061 -11.5856 +9721 4 52.5233 26.307 21.7841 0.332471 11.3908 13.792 +9722 4 52.7558 27.2791 20.7178 5.02488 16.4903 -8.77251 +9723 6 7.3066 16.9604 33.5537 -1.04195 2.49046 -7.43677 +9724 4 7.33543 17.7138 32.943 1.81348 -0.803559 0.920864 +9725 4 6.38938 16.6816 33.595 -7.62852 -0.129201 -7.36731 +9726 6 43.922 25.2186 7.97522 -0.776236 -10.551 19.3716 +9727 4 43.2647 24.8119 8.58447 10.2741 2.86697 -16.6436 +9728 4 43.4353 25.9147 7.53069 -5.46224 6.25576 -5.43654 +9729 6 2.0869 27.1165 13.6049 -6.62274 17.6596 -9.16822 +9730 4 2.19606 26.2295 13.9488 0.235583 -10.4047 3.43352 +9731 4 2.56841 27.1544 12.7597 2.10867 -4.70259 8.20201 +9732 6 37.3318 18.2771 2.1863 -11.4974 3.81579 3.71073 +9733 4 37.5653 17.6745 1.47223 -1.7687 -9.97531 1.83125 +9734 4 36.746 18.9091 1.7765 -5.93566 5.03593 -3.95155 +9735 6 24.9999 10.057 0.434977 -12.0635 -2.74649 0.799886 +9736 4 24.3308 10.4048 41.7106 3.78591 -9.33137 12.164 +9737 4 24.5954 9.37599 1.02184 5.69483 17.6459 -16.041 +ITEM: TIMESTEP +10 +ITEM: NUMBER OF ATOMS +9737 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 5.4990000000000002e+01 +0.0000000000000000e+00 4.1909999999999997e+01 +0.0000000000000000e+00 4.1909999999999997e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 9.97007 5.59928 0.0158605 6.82717 25.1566 0.173859 +2 2 9.62356 5.56404 40.5109 2.42388 15.8202 -17.9785 +3 2 8.17494 6.05177 40.4142 55.7411 37.9916 -4.02595 +4 3 7.24177 5.30408 40.552 -31.6102 -16.3698 1.50252 +5 4 9.18703 5.26911 0.576869 6.09491 -0.0281501 2.37507 +6 4 10.258 6.55078 0.333037 -13.6694 -25.1619 -9.93433 +7 4 10.7495 5.00053 0.227298 4.73684 -5.2578 1.97242 +8 4 10.3453 6.24708 39.9044 -16.4644 -11.4072 20.4818 +9 2 9.76873 4.13927 39.9675 -11.4588 -40.6165 34.779 +10 2 9.50273 3.78744 38.4932 15.666 28.6261 8.68394 +11 5 10.1133 2.12508 38.0108 0.295651 13.5297 3.11239 +12 2 9.21855 1.10832 39.2168 14.7368 7.58368 -1.20954 +13 4 9.08721 3.4839 40.6484 10.5431 15.7462 -21.5186 +14 4 10.7894 3.80905 40.2705 3.27862 -1.66199 -9.78219 +15 4 9.96352 4.6291 37.9056 6.4614 -19.967 -0.497951 +16 4 8.45197 3.92389 38.2658 -20.9649 -8.28542 -1.62155 +17 4 9.45855 1.42591 40.2577 0.123087 -4.74543 -3.47868 +18 4 9.48787 0.0601841 39.0477 5.23249 -11.9374 1.58081 +19 4 8.1518 1.18086 39.043 -21.148 5.31153 -2.14239 +20 1 8.09229 7.41048 40.3029 -14.2332 10.7223 -5.89196 +21 2 6.79937 8.10304 40.1889 5.24089 -19.8495 27.4218 +22 2 6.18195 7.49232 38.9365 0.114954 6.75236 -38.7125 +23 3 6.7427 7.67352 37.8124 -12.8129 -5.94191 21.2876 +24 4 8.91546 8.03754 40.1502 -4.33809 -15.705 2.93584 +25 4 6.18636 7.83053 41.1247 8.71228 4.86543 -21.2479 +26 2 7.05427 9.64124 40.1755 -39.1485 4.05492 14.7867 +27 2 5.78354 10.5475 40.1236 1.30256 17.7056 10.1762 +28 2 4.88546 10.5193 38.8862 -3.79578 -25.0164 33.8013 +29 3 5.09523 11.2746 37.9701 4.75276 20.2207 -26.2166 +30 1 3.8145 9.69296 38.9578 -10.6259 3.8922 -22.0733 +31 4 7.59986 9.93872 39.279 22.1314 0.316188 -7.87442 +32 4 7.59095 9.90263 41.1476 2.09094 2.02455 -19.3111 +33 4 6.10317 11.6308 40.2015 3.5236 -15.0099 -9.27626 +34 4 5.16114 10.4864 41.0336 -3.30627 -13.4665 3.57605 +35 4 3.54863 9.07856 39.7488 8.69916 3.95403 -0.745788 +36 4 3.18874 9.68238 38.1158 12.5738 1.24403 17.0425 +37 1 5.02604 6.79083 39.0278 7.4524 -0.797845 -45.9123 +38 2 4.17847 6.29332 37.9221 -3.7942 -15.2224 -3.95324 +39 2 2.69747 6.67222 38.2029 32.4064 16.6491 21.8024 +40 3 2.47317 7.27763 39.2627 -13.9875 -5.03172 -5.20453 +41 4 4.49693 6.75941 39.8611 -16.5463 3.77927 46.4214 +42 4 4.45927 6.7815 36.9606 1.68834 7.22657 1.16434 +43 2 4.32357 4.73766 37.6872 -14.444 16.6417 -7.09057 +44 2 3.62009 3.87951 38.7772 14.6644 -34.8859 1.43809 +45 2 5.79989 4.34797 37.5209 14.6689 -37.6664 -23.8861 +46 2 3.73665 2.34984 38.4383 -15.0607 27.3941 -9.62179 +47 4 3.8042 4.58537 36.6865 5.44811 -8.07725 9.84866 +48 4 2.54132 4.09064 38.8487 -7.82462 7.38089 1.0406 +49 4 4.05844 4.00808 39.8052 -1.99007 7.91776 -7.51683 +50 4 6.34139 4.39198 38.494 2.7915 9.59572 -3.8015 +51 4 6.26587 4.94741 36.6895 -0.816692 -0.0793993 15.4171 +52 4 5.96503 3.2496 37.1567 -11.5696 29.092 9.48874 +53 4 3.39623 2.18998 37.357 4.41378 -5.40883 18.8177 +54 4 3.12239 1.76276 39.1489 -5.35757 -4.6989 -2.16583 +55 4 4.76682 2.00075 38.5743 10.6291 -5.64517 -2.52342 +56 1 1.71265 6.3536 37.3575 -33.5913 -12.5481 -9.77554 +57 2 0.284755 6.62158 37.6816 12.6554 33.7668 -4.20076 +58 2 54.3822 5.43344 37.3699 -27.7691 3.87457 8.29319 +59 3 54.7838 4.49252 36.6867 3.01204 -3.04336 -3.37779 +60 4 1.82497 5.72672 36.5372 4.10411 3.68048 5.38879 +61 4 0.194803 6.88576 38.7694 2.48378 -12.979 2.09758 +62 2 54.7189 7.90551 36.9466 -7.72609 -12.13 5.61678 +63 2 0.656639 9.069 36.6919 -2.01357 8.03554 13.9604 +64 2 1.52683 9.2194 35.5966 7.55435 5.75852 -14.6577 +65 2 0.515029 10.1503 37.577 28.0972 23.5099 -14.6501 +66 2 2.25128 10.4257 35.3726 -4.96866 -39.5758 -10.6477 +67 2 1.27413 11.3326 37.3973 2.53894 16.486 1.64204 +68 2 2.1477 11.4375 36.2812 10.2448 65.1187 39.3263 +69 4 53.8018 8.25583 37.5371 13.1335 -2.90056 -11.9634 +70 4 54.3208 7.62968 35.9579 -2.73912 -6.0948 -8.85904 +71 4 1.62786 8.40831 34.848 -1.08621 1.70246 3.68663 +72 4 54.8519 10.113 38.4282 -15.3846 -1.92761 17.9785 +73 4 2.932 10.5406 34.5118 -0.192368 -3.19302 0.526177 +74 4 1.1987 12.2443 38.1226 0.692592 -32.2473 -20.0357 +75 4 2.79857 12.4271 36.2097 -23.9561 -41.0367 -3.09354 +76 1 53.0712 5.5328 37.7893 -5.57771 32.7805 23.2413 +77 2 51.973 4.62909 37.5111 5.69369 -27.8287 -42.174 +78 2 50.7933 5.44178 36.9635 6.83138 2.9595 14.8019 +79 3 50.2601 6.28483 37.7029 -2.00888 -3.43203 -15.9694 +80 4 52.7232 6.34215 38.4237 19.8206 -30.3225 -23.0649 +81 4 52.294 3.8899 36.6472 -5.7065 17.91 27.0613 +82 2 51.558 3.79481 38.7755 -4.51595 7.33433 1.21121 +83 2 50.3828 2.83682 38.5018 -9.13901 -44.4412 -29.5986 +84 2 52.8166 3.00155 39.2294 -15.7012 -7.04664 11.9409 +85 4 51.1774 4.47766 39.5861 12.1653 -0.853429 -2.8896 +86 4 50.5215 2.15128 37.5875 8.57056 17.9281 16.1392 +87 4 49.4053 3.30815 38.2892 0.50336 12.9055 3.57196 +88 4 50.1645 2.10956 39.3273 7.20165 10.7054 2.61524 +89 4 53.3305 3.56036 40.0335 2.85201 1.25263 3.90533 +90 4 53.556 2.88446 38.4204 4.77396 -6.45058 -3.13498 +91 4 52.5519 1.98529 39.6413 5.25091 8.27159 -2.68354 +92 1 50.4114 5.20625 35.6841 -20.1476 8.87025 -3.50293 +93 2 49.1688 5.73971 35.0966 -28.9774 8.99335 -1.66554 +94 2 48.0726 4.67952 35.3573 13.5632 -27.7837 -20.7653 +95 3 48.2724 3.51151 34.9309 -12.9152 20.0019 12.3092 +96 4 50.758 4.377 35.1895 1.67728 -2.63512 -1.50997 +97 4 48.8371 6.69602 35.5973 10.748 -7.18216 5.66994 +98 2 49.2038 6.04752 33.5367 10.0422 21.5226 29.5984 +99 2 47.9776 6.84135 32.9981 5.60977 17.6728 -19.5296 +100 2 48.06 7.31101 31.4919 41.3779 8.51018 8.58065 +101 2 48.2223 6.22581 30.3803 10.2277 10.7815 -8.37061 +102 1 48.1882 6.76889 29.0124 -44.0668 -20.3552 -6.98541 +103 4 49.2392 5.11894 32.9842 10.5057 -23.1259 -12.3022 +104 4 50.1653 6.62923 33.3927 -11.345 -5.02104 -10.4632 +105 4 47.825 7.77207 33.6051 2.48464 -5.23088 2.05035 +106 4 47.0343 6.2773 33.0942 -1.95432 -7.79908 6.21428 +107 4 48.9189 8.07819 31.4105 -13.7973 -19.6161 -0.159439 +108 4 47.1832 7.92091 31.2683 -17.7289 5.61577 -2.96622 +109 4 47.3306 5.536 30.4593 16.0468 -5.76301 1.4082 +110 4 49.2642 5.74618 30.4425 -24.8663 -4.45667 9.08666 +111 4 48.9827 7.28362 28.7526 29.3958 17.558 -6.10605 +112 4 47.3901 7.43056 28.8463 17.4375 -26.0151 1.0329 +113 4 48.1308 5.99149 28.2967 -4.23626 26.2635 18.8845 +114 1 46.923 5.03715 35.9679 -17.5656 23.7329 15.0201 +115 2 45.6707 4.26397 36.0383 7.41887 0.1342 36.2715 +116 2 44.9083 4.3955 34.7419 -9.99807 18.7078 -56.0122 +117 3 45.3082 5.1515 33.8118 -11.5681 -21.3087 27.1246 +118 4 46.8218 5.98238 36.4144 8.23522 -16.4135 -11.8728 +119 4 45.8989 3.17264 36.1884 2.80321 2.94058 -5.13324 +120 2 44.7401 4.70263 37.2808 -1.60464 -36.3649 -20.2774 +121 3 44.4616 6.07663 37.208 27.8602 32.4116 16.0792 +122 2 45.244 4.25605 38.6868 21.6281 49.2853 -20.5016 +123 4 43.7497 4.17807 37.1099 13.0537 7.54308 5.65065 +124 4 45.2592 6.57873 37.5303 -28.9412 -17.1189 -11.5145 +125 4 45.9129 5.11546 39.1089 -19.7485 -23.953 -1.10378 +126 4 45.8752 3.36487 38.6536 3.71139 -12.8851 -1.61893 +127 4 44.3595 4.03827 39.3021 -3.33201 1.23649 16.0156 +128 1 43.7613 3.66416 34.5997 13.2589 -16.0433 44.4251 +129 2 42.7828 3.62815 33.5465 18.9204 -1.21878 -42.6601 +130 2 41.7763 4.78741 33.7016 8.26701 -3.22526 52.4496 +131 3 41.2647 5.35582 32.7525 -2.05798 3.57411 -28.7638 +132 4 43.4932 3.04471 35.4154 4.99312 14.665 -20.8764 +133 4 43.36 3.79542 32.5266 -17.2288 -0.741434 30.8189 +134 2 42.0901 2.2209 33.4572 -3.06831 -30.079 -8.91003 +135 2 42.9343 0.899345 33.7586 6.86735 -2.69949 -8.81151 +136 2 42.2038 41.463 33.3849 1.50493 16.9918 14.9247 +137 2 44.2499 0.864187 32.9361 47.2855 12.5868 41.6398 +138 4 41.5678 2.05281 32.481 6.79941 12.0418 -2.16148 +139 4 41.2531 2.16469 34.1657 -6.29243 10.0771 8.19014 +140 4 43.198 0.869694 34.8519 -1.4112 0.953999 -4.44245 +141 4 42.8702 40.5903 33.6002 -4.10478 0.398246 -9.68788 +142 4 41.7896 41.4589 32.3582 7.27854 -3.68783 -7.38435 +143 4 41.3262 41.3063 34.0224 -6.75638 1.39507 6.42691 +144 4 44.0947 0.829251 31.8728 -5.75954 4.64229 -28.5029 +145 4 44.9396 41.8855 33.1737 -20.9549 12.1515 -1.19165 +146 4 44.9309 1.76601 33.2059 -22.5069 -20.3291 -10.4095 +147 1 41.5145 5.2236 34.9901 10.2672 4.08625 -51.0356 +148 2 40.6676 6.35891 35.268 -24.1778 -10.7223 -7.79527 +149 2 41.3691 7.72376 35.0974 2.95483 13.7574 -3.11119 +150 3 40.6975 8.75349 34.8431 -2.15612 -12.5202 3.44484 +151 4 41.8176 4.64617 35.7553 2.04542 -7.36824 24.1106 +152 4 39.8621 6.3427 34.4551 10.5786 9.41727 7.44594 +153 2 39.8405 6.1283 36.5756 19.8539 -2.67173 26.8296 +154 3 40.7601 5.89106 37.6735 -0.128972 20.3018 -14.678 +155 2 38.9248 4.89402 36.5497 -24.3083 -6.19306 -11.8519 +156 4 39.228 7.01129 36.8511 -0.372961 8.24506 -6.20484 +157 4 41.1549 6.75425 37.8536 -4.13097 -9.7211 -3.01543 +158 4 38.1722 4.94482 35.71 1.05658 9.14576 13.4136 +159 4 38.3953 4.71355 37.5213 -1.28546 9.2328 -6.30902 +160 4 39.3771 3.92967 36.3433 23.1336 -11.0543 -1.24287 +161 1 42.7302 7.8059 35.1562 3.49276 1.34371 4.78693 +162 2 43.5269 8.99303 34.9539 -8.19772 -21.7996 13.9087 +163 2 44.4646 9.39471 36.0778 41.0762 49.5413 -62.5687 +164 3 45.3993 10.2183 35.7654 -29.643 -36.0587 21.7786 +165 4 43.357 7.05719 35.4614 -7.13629 -15.5308 5.06399 +166 4 44.0803 8.92821 34.0189 14.2015 -9.60403 -10.8131 +167 4 42.9032 9.83742 34.7399 -16.6431 23.0824 1.78637 +168 1 44.28 8.95267 37.3076 -5.41717 -6.01048 56.4016 +169 2 45.1954 9.30059 38.3934 14.0544 9.09198 9.45122 +170 2 46.5736 8.71838 38.034 -4.40481 25.0392 4.24124 +171 3 46.7239 7.52665 37.7592 -2.06685 -10.8071 -7.31186 +172 4 43.4369 8.46722 37.66 -0.808029 1.80219 -13.797 +173 4 45.2932 10.4319 38.4595 -5.35026 -12.3633 -15.6489 +174 2 44.7775 8.83735 39.8303 19.1756 -23.9015 -7.23155 +175 2 45.4882 9.63492 40.9425 5.24315 -15.5914 27.8506 +176 2 45.0424 11.1143 41.0465 6.36216 -11.291 -10.339 +177 2 45.9827 11.9035 0.041605 38.3537 -2.96327 34.4916 +178 1 45.5586 13.2421 0.396463 -0.785075 15.3756 28.9492 +179 4 44.9912 7.72238 39.9953 -4.79728 17.8629 -7.78445 +180 4 43.7049 8.96345 39.9422 -22.2512 0.44531 4.07292 +181 4 46.5908 9.56019 40.8161 0.364544 3.82252 -6.52459 +182 4 45.3434 9.10335 0.0599805 -5.24686 13.9981 -23.7842 +183 4 44.0132 11.1324 41.4274 -10.2695 3.39123 6.70816 +184 4 44.9981 11.6023 40.04 1.8072 0.416607 6.15726 +185 4 47.0442 11.9436 41.5493 -17.6115 6.73335 -5.13538 +186 4 46.1824 11.4052 1.05233 -16.0491 -0.928483 -18.7699 +187 4 45.666 13.9003 41.5429 -6.15709 2.25656 -0.794581 +188 4 46.187 13.6261 1.17403 -31.6799 -14.737 -27.4943 +189 4 44.5482 13.2658 0.707841 33.0262 6.71149 -7.77427 +190 1 47.5786 9.61919 37.9975 -0.262725 18.6124 2.96873 +191 2 48.9681 9.33197 37.6414 -20.2336 1.72319 -17.1083 +192 2 49.7588 9.70622 38.88 39.5209 -76.7499 14.8721 +193 3 49.6145 10.763 39.4317 -9.44289 38.5374 13.5639 +194 4 47.4009 10.6083 38.3248 7.77058 -18.5649 -8.96176 +195 4 49.0172 8.23798 37.4216 9.46753 0.884559 0.506936 +196 2 49.3323 10.1282 36.3163 3.6714 0.82331 31.2642 +197 3 48.3563 9.85046 35.3281 -8.1318 -4.77519 -4.71381 +198 2 50.6865 9.72677 35.695 -19.0046 0.743943 -11.7808 +199 4 49.2557 11.2077 36.6021 8.67648 2.0602 -8.11811 +200 4 47.5419 10.2678 35.5977 -2.15846 0.170791 -0.678761 +201 4 50.8563 10.2671 34.7416 2.67544 8.24981 1.47477 +202 4 50.7066 8.66813 35.3754 2.1247 -7.47433 7.78713 +203 4 51.5309 9.954 36.3541 9.43429 -0.352141 7.40173 +204 1 50.5004 8.65755 39.48 -48.513 49.986 -45.0014 +205 2 51.0618 8.74392 40.7907 20.8089 -26.4742 28.5407 +206 2 52.5708 8.35776 40.7906 -32.7343 -31.0986 -30.3541 +207 3 52.9098 7.36002 40.1044 19.6712 31.5314 12.7437 +208 4 50.5882 7.8265 38.898 12.8881 -18.9119 10.2231 +209 4 50.9863 9.78895 41.141 -1.46865 8.60563 4.12328 +210 2 50.3037 7.79505 41.8358 -16.725 28.936 13.8764 +211 2 50.252 6.27959 41.4904 27.2589 15.6434 -4.64867 +212 2 48.8609 8.35011 0.225019 8.85004 14.588 -17.6069 +213 2 49.3953 5.42325 0.497373 -18.8945 7.05888 30.2377 +214 4 50.814 7.95159 0.918621 8.35305 -8.94958 -7.30269 +215 4 51.3186 5.93048 41.4774 -6.84536 -5.23847 5.64953 +216 4 49.9408 6.1608 40.4387 -8.33431 -3.05112 -5.55566 +217 4 48.166 7.96072 41.344 -1.46 7.63128 5.53427 +218 4 48.8165 9.51657 0.246026 0.467008 -30.2893 -0.065267 +219 4 48.5175 7.97406 1.21641 -4.07563 3.27994 -1.48455 +220 4 48.2983 5.58085 0.347667 5.50609 -0.627552 -5.84055 +221 4 49.5344 5.58322 1.60624 7.63779 5.91871 -13.4594 +222 4 49.5909 4.36583 0.361303 3.03099 -20.7712 -9.01704 +223 1 53.3669 9.15083 41.5136 39.5682 14.7354 5.79836 +224 2 54.8443 9.26777 41.6313 -32.7918 27.0996 3.53674 +225 2 0.372396 8.2907 0.722751 15.0567 -33.4937 20.6099 +226 3 54.8856 8.2259 1.87915 11.4238 -3.26125 -20.3466 +227 4 52.9167 9.73978 0.288924 -10.841 14.2188 11.5997 +228 4 0.25416 9.07559 40.636 9.98484 -5.7038 -17.1316 +229 2 0.351513 10.7152 0.19938 0.985642 14.1538 -10.6635 +230 3 54.4575 11.7797 41.7528 -11.3464 -18.6066 -9.73211 +231 2 1.66903 11.1049 41.4122 7.34382 -22.4378 -10.8926 +232 4 0.4803 10.8256 1.29559 2.15483 -15.9854 6.57991 +233 4 54.1789 12.1729 0.660397 -4.76608 7.18995 2.46446 +234 4 2.02372 12.0909 41.706 2.9877 17.6459 6.95349 +235 4 1.57896 11.139 40.2943 0.339955 -2.68366 6.65003 +236 4 2.50746 10.4017 41.6821 -7.50419 3.69742 -2.77337 +237 1 1.45709 7.55056 0.343709 0.783377 10.0466 -6.42735 +238 2 2.26763 6.65075 1.15078 -32.6055 -6.94536 -7.22798 +239 2 3.71498 6.9634 0.985171 49.9575 39.4499 -62.468 +240 3 4.16139 7.41516 41.7733 -24.7374 -20.1855 46.264 +241 4 1.86812 7.64334 41.3079 -3.10568 2.79536 2.39364 +242 4 2.02547 6.77359 2.21072 -7.15361 5.99983 10.1715 +243 2 1.97017 5.19949 0.677115 9.24237 23.8034 -8.70369 +244 2 0.525 4.76245 0.942436 -1.25511 -23.3688 27.6866 +245 2 0.292475 3.39123 0.300736 12.896 -21.1671 11.4366 +246 2 0.300138 4.59931 2.47443 -32.0383 1.7301 9.08136 +247 4 2.70003 4.54767 1.15632 6.2908 -16.3803 10.1517 +248 4 2.22696 5.13751 41.5068 -3.29253 -1.30987 -4.15087 +249 4 54.7656 5.47042 0.590489 -8.39992 14.3218 -15.0438 +250 4 54.2418 3.05018 0.328915 -13.2626 1.11831 3.00682 +251 4 0.884488 2.58096 0.823664 -4.50955 14.351 -5.98985 +252 4 0.593908 3.34298 41.1636 3.48003 3.40906 -16.1017 +253 4 0.952355 3.83641 2.92287 8.67303 -5.41594 2.10418 +254 4 54.195 4.2418 2.71744 29.7111 15.4634 -7.25797 +255 4 0.523461 5.5584 3.03176 -8.55492 -11.4476 -4.98522 +256 1 4.54724 6.69628 2.0028 -11.6083 -5.66543 -5.23244 +257 2 5.9708 6.78048 2.07185 29.6953 24.7002 11.5216 +258 2 6.62679 5.47067 2.57826 -56.9161 -25.5018 -48.7527 +259 3 7.55514 5.44421 3.3345 43.3901 -4.04961 27.9945 +260 4 4.11753 6.29088 2.82459 -1.31884 -6.15538 19.0144 +261 4 6.38329 6.99012 1.0501 -1.44469 -12.2628 1.79191 +262 2 6.4556 7.99651 2.97484 -29.1307 10.2847 -18.0571 +263 2 6.5028 9.34873 2.22705 -18.2939 24.7932 5.04877 +264 2 6.67525 10.5485 3.20576 -19.6949 -28.8822 -17.9407 +265 3 7.83409 10.9407 3.49149 14.4815 4.00472 5.8048 +266 3 5.6204 11.0576 3.67938 3.00737 1.04452 3.25275 +267 4 7.46376 7.72864 3.29072 15.5933 3.84479 14.8832 +268 4 5.82416 8.22265 3.87848 3.62309 -20.6245 -0.107855 +269 4 5.50278 9.55154 1.65377 27.7023 -9.35583 7.15892 +270 4 7.36204 9.37759 1.52673 -1.86837 -2.39822 -10.1271 +271 1 6.01547 4.32119 2.13096 24.825 18.8056 21.8908 +272 2 6.40109 2.94617 2.38906 -11.7575 -20.1643 -12.9237 +273 2 7.81521 2.61654 1.77783 -56.2322 2.45294 33.4207 +274 3 8.31478 3.35811 0.966233 17.239 19.087 -22.9985 +275 4 5.23593 4.40493 1.50032 -13.4301 6.78787 -12.4159 +276 4 6.42741 2.74871 3.48587 6.57798 6.02642 3.28221 +277 2 5.2086 2.00284 1.82478 32.9723 -19.5112 -16.552 +278 2 3.90497 2.10853 2.63909 4.11684 35.775 58.6384 +279 2 4.90372 2.28313 0.318971 -25.0993 -16.9694 6.10511 +280 4 5.56913 0.900136 1.85726 -4.66192 22.2662 6.6067 +281 4 4.03562 1.77943 3.74204 2.08752 -4.13501 -29.3045 +282 4 3.08076 1.58512 2.20328 -21.6762 -25.4002 -11.7361 +283 4 3.47043 3.14079 2.79739 15.5883 -5.24062 -11.8252 +284 4 4.40039 3.24668 0.146776 -5.79992 5.24774 -1.28692 +285 4 4.20501 1.47402 41.8336 8.41255 14.6516 3.66501 +286 4 5.77159 2.28177 41.569 16.6343 -1.64949 -4.80555 +287 1 8.4358 1.54559 2.27475 36.6082 -11.5601 -11.8896 +288 2 9.77403 1.09441 1.8307 -27.8835 12.6882 -14.7267 +289 2 9.60932 41.7912 0.904414 -8.95822 -4.80133 -2.77359 +290 3 8.60977 41.0717 1.04857 16.9017 -0.350054 -8.54673 +291 4 7.96937 0.851078 2.83344 -16.1443 -13.3321 15.6909 +292 4 10.1447 1.96102 1.23179 21.7718 -7.90657 2.9301 +293 2 10.6071 0.627222 3.03652 -0.441548 -3.06629 28.3632 +294 2 11.1182 1.69736 4.03374 -39.6019 -9.33118 23.345 +295 2 12.4276 2.26482 3.60541 40.3504 -3.80329 2.03759 +296 3 13.4833 1.65854 4.00477 -10.9735 16.3163 -6.96273 +297 3 12.4619 3.21875 2.76405 -4.75337 -1.04793 7.93588 +298 4 11.5429 0.117807 2.72279 -4.90068 -9.43781 -6.0473 +299 4 9.98495 41.7532 3.61242 16.0495 13.2539 -10.4034 +300 4 11.2741 1.17979 5.05068 -3.18835 9.28581 -16.8758 +301 4 10.3234 2.48031 4.23808 10.2695 -6.11036 -3.24845 +302 1 10.6563 41.4604 0.0588169 -6.20046 -15.666 -8.24155 +303 2 10.7096 40.1842 41.1911 4.64874 21.5238 9.65168 +304 2 10.6577 38.9638 0.161439 -6.67174 -46.3648 23.9629 +305 3 10.1435 37.8848 41.6696 11.1653 29.5239 15.2576 +306 4 9.85832 40.1011 40.5066 -14.3391 4.69386 -5.52668 +307 2 12.0141 40.2124 40.3653 4.26726 1.71904 -5.44169 +308 2 12.4668 41.6661 40.4777 -1.00635 15.6111 -33.0282 +309 2 11.8673 0.323303 41.767 -12.6506 -21.5702 -15.1443 +310 4 11.8545 39.873 39.2959 0.539662 6.91875 10.5587 +311 4 12.8304 39.5641 40.7546 -3.32338 -3.68521 7.20301 +312 4 12.0951 0.327352 39.5607 -0.26902 -6.73625 15.8499 +313 4 13.5766 41.7696 40.398 -3.05617 -0.547794 6.53436 +314 4 11.6542 1.3898 41.6565 2.06281 16.0871 1.21765 +315 4 12.5433 0.162045 0.691867 15.5992 2.8717 16.0141 +316 1 11.2193 39.0766 1.4086 -4.36655 24.7542 -22.059 +317 2 11.4309 38.0888 2.42328 2.01986 -2.25877 10.0578 +318 2 10.2357 37.7662 3.3374 -3.13249 5.62439 -12.9442 +319 3 10.4243 36.9709 4.25096 -6.41092 -9.96708 1.94465 +320 4 11.5904 40.0068 1.66465 -1.36758 -8.10945 4.45955 +321 4 11.6246 37.1209 1.91909 1.66244 -5.96089 -4.69733 +322 2 12.7089 38.4628 3.26447 -19.7243 1.96837 18.865 +323 3 12.593 39.7548 3.85012 -16.3579 -13.4437 -0.292868 +324 4 13.6002 38.4999 2.63657 13.9756 -7.10852 -11.694 +325 4 12.8962 37.7302 4.10036 -1.36843 4.44789 -10.4248 +326 4 11.9859 39.6657 4.60642 10.4094 13.6351 -5.41979 +327 1 9.02275 38.3618 3.12708 -24.8633 34.0603 -47.8229 +328 2 7.7797 38.1104 3.9237 -5.5143 -4.40103 -12.4219 +329 2 6.80948 37.1627 3.16843 27.134 16.5749 8.61656 +330 3 6.86683 37.0056 1.95165 6.52379 13.0808 -10.3152 +331 4 8.81363 38.9852 2.21874 13.7891 -35.0234 50.9651 +332 4 8.06628 37.5753 4.84119 7.22917 -10.5654 7.4735 +333 2 7.01568 39.4093 4.3407 2.69101 -11.9593 -14.7657 +334 2 7.81876 40.1019 5.42325 -6.79454 3.60365 -28.1432 +335 3 8.28496 41.241 5.20721 -2.75331 10.4655 -0.123769 +336 3 8.08719 39.4782 6.47272 0.652509 -5.2024 22.4807 +337 4 5.97814 39.1687 4.67547 5.82193 1.31451 7.85599 +338 4 6.83632 40.0167 3.42407 6.48365 7.00102 3.75656 +339 1 5.92582 36.4787 3.90047 -14.2639 -13.8348 21.4567 +340 2 4.95916 35.6178 3.24268 -4.4575 6.83929 8.3992 +341 2 3.83929 36.4769 2.71202 -44.4588 -49.3176 -48.5312 +342 3 3.60925 37.6169 3.05258 2.07424 26.7384 14.4764 +343 4 5.8145 36.534 4.942 7.63157 5.21975 -16.3776 +344 4 5.40617 35.1414 2.34351 4.65472 -4.22423 0.555341 +345 2 4.39718 34.509 4.16235 13.2774 -34.7614 9.16528 +346 3 3.98438 35.0519 5.39575 -10.4467 6.31908 32.28 +347 2 5.50619 33.4543 4.48033 -18.4692 -3.54598 29.0115 +348 4 3.53919 33.9402 3.74776 -4.47694 5.79242 -10.2957 +349 4 3.62452 34.3759 6.00064 11.5458 5.5573 -22.0279 +350 4 5.86065 32.9579 3.58801 8.19644 -6.15464 -22.9143 +351 4 5.08151 32.5761 5.12909 16.3877 29.7333 -11.6263 +352 4 6.39565 33.9521 4.95041 -3.85278 -8.84208 3.35803 +353 1 2.97294 35.7888 1.83357 24.6732 25.9217 25.2152 +354 2 1.71267 36.3687 1.37347 -5.03432 -5.896 10.5631 +355 2 0.744229 36.5497 2.58991 -5.24139 24.3125 -23.8477 +356 3 54.9871 37.5497 2.63122 18.6385 -17.0409 3.73872 +357 4 3.28773 34.8825 1.44268 -6.98273 2.93822 -0.272558 +358 4 1.87243 37.434 1.07109 4.86902 -3.5162 -5.74397 +359 2 1.111 35.5523 0.154125 -16.9781 -2.34719 28.1775 +360 2 1.71191 35.9998 40.7076 5.75717 0.931703 -28.4951 +361 2 54.5365 35.7134 0.116808 -8.16561 0.919103 1.38616 +362 2 3.27145 35.9095 40.6267 -43.0781 7.09941 -3.6072 +363 4 1.31237 34.4411 0.36052 2.96229 18.9121 -10.1464 +364 4 1.38444 37.0145 40.3207 4.07875 -5.77915 19.4423 +365 4 1.27316 35.3433 39.9124 8.37762 -5.40948 6.65521 +366 4 54.0772 35.0942 41.2103 3.74338 3.48587 4.89864 +367 4 54.2123 36.7722 41.8688 5.5832 -2.69651 -3.34762 +368 4 54.0157 35.4055 1.08169 10.5414 -0.491815 -14.4897 +369 4 3.61367 34.902 40.8802 7.83264 -12.2373 1.45006 +370 4 3.69229 36.6315 41.3343 12.2091 5.94613 6.19684 +371 4 3.59275 36.1798 39.604 6.95495 -3.49191 -4.00644 +372 1 0.74604 35.6172 3.54454 -3.3388 -35.9018 49.598 +373 2 0.0112331 35.6552 4.85892 21.257 7.22823 -39.6883 +374 2 0.198256 37.0471 5.48367 -2.86302 -31.8341 -17.2866 +375 3 54.1912 37.6952 5.75353 -1.48181 26.0574 3.92406 +376 4 1.16676 34.6739 3.4098 -0.571923 12.3969 -9.16993 +377 4 53.9399 35.5324 4.59955 -13.6683 1.62606 4.36563 +378 2 0.479844 34.4894 5.77304 -8.63544 -0.437888 22.4632 +379 2 54.7769 34.3327 7.14546 -8.87326 -9.27459 2.92058 +380 2 0.0146857 35.4787 8.12524 6.60033 -5.57439 2.5368 +381 3 54.0952 36.3427 8.3329 8.35004 -1.43527 5.86114 +382 3 1.11008 35.478 8.75909 4.47833 6.11486 1.03148 +383 4 1.57132 34.5563 5.98457 -0.698959 1.91632 -4.64924 +384 4 0.309529 33.5134 5.28188 2.4365 -3.54209 -11.468 +385 4 0.179249 33.4003 7.64738 0.479338 5.67065 -5.66203 +386 4 53.6776 34.105 7.04833 9.83525 6.91672 -4.06122 +387 1 1.48459 37.3964 5.63734 26.9411 18.0032 -4.38534 +388 2 2.00708 38.6625 6.18614 -17.3218 -26.0277 -29.9987 +389 2 1.56827 39.8885 5.33406 1.07082 -15.6319 68.2882 +390 3 1.08143 40.8395 5.94485 1.04665 3.34176 -10.6171 +391 4 2.21263 36.6994 5.39095 -3.57075 5.04293 0.958686 +392 4 1.48422 38.7142 7.17744 15.2971 12.5748 0.959573 +393 2 3.55969 38.5843 6.25222 7.32448 -15.8569 15.0135 +394 2 4.09689 39.7132 7.09894 -5.63198 1.92213 9.01267 +395 3 4.56636 40.7179 6.56654 0.030916 3.04529 -1.1693 +396 1 3.96361 39.556 8.43894 1.042 12.9555 16.4237 +397 4 4.05831 38.7157 5.24953 -10.2579 -5.90723 4.64011 +398 4 3.91694 37.5778 6.70114 -5.07122 23.1073 -10.2752 +399 4 3.40266 38.7698 8.86734 10.6722 14.2638 -7.23316 +400 4 4.31989 40.3411 9.06061 -10.7144 -22.9188 -14.0526 +401 1 1.60475 39.819 4.02334 -43.55 39.5967 -43.6917 +402 2 0.959151 40.8062 3.12947 9.93922 10.0651 20.657 +403 2 54.4776 41.0208 3.48285 -52.4492 -13.4217 15.5726 +404 3 53.9715 0.237442 3.65017 19.1527 -10.2385 2.60078 +405 4 2.04263 39.1125 3.49268 25.4866 -43.7222 -11.6271 +406 4 1.43469 41.7946 3.36052 -1.16639 -0.650149 -3.04645 +407 2 1.13376 40.5205 1.61049 -4.45578 -2.70165 -27.9407 +408 2 0.490261 41.6149 0.695896 4.53105 0.20202 29.6943 +409 2 2.64975 40.4484 1.23692 -3.92583 -1.39436 -18.6979 +410 4 0.60342 39.5705 1.32385 8.41785 -1.89228 7.96418 +411 4 54.3692 41.6195 0.82936 4.25856 9.6792 3.81375 +412 4 0.622371 41.4492 41.5424 7.52435 -6.48816 -19.7965 +413 4 0.973053 0.688907 0.936332 -12.1275 -4.49455 -2.44597 +414 4 2.86969 40.4983 0.122209 -12.9804 -12.5133 18.6513 +415 4 3.14027 39.5547 1.69882 2.20392 3.04031 -6.93039 +416 4 3.17994 41.3387 1.56797 8.55742 10.8937 16.8775 +417 1 53.6665 39.902 3.64569 3.02926 35.878 11.6697 +418 2 52.2466 39.9148 4.06102 19.2385 27.0707 -26.8098 +419 2 52.053 40.5369 5.44904 5.36155 -11.3244 -6.70427 +420 3 51.0493 41.2119 5.6977 3.00195 1.8183 -1.23959 +421 4 54.0359 38.9941 3.4462 12.1828 -26.316 -3.91411 +422 4 51.7731 40.6655 3.34079 -4.82064 -14.7659 11.8755 +423 2 51.582 38.5149 3.95778 -5.61462 -20.1546 -9.91009 +424 2 51.4355 37.9559 2.49174 21.0062 -12.2216 22.8132 +425 2 51.0144 36.4629 2.37849 -12.7289 -13.0945 -11.3158 +426 2 50.8009 35.9817 0.883468 22.3055 45.8074 13.5352 +427 1 50.1864 34.6873 0.684667 2.36531 28.1154 -10.556 +428 4 50.5344 38.5648 4.38466 13.3699 -2.49694 2.21203 +429 4 52.2198 37.7725 4.53757 -13.8611 9.51826 -2.20414 +430 4 52.4594 37.9738 2.01537 -10.7122 14.3169 -4.94324 +431 4 50.6781 38.6054 2.01085 7.27079 0.282464 -15.5314 +432 4 50.0599 36.3043 2.92579 -2.19776 -0.350037 2.41174 +433 4 51.7586 35.7685 2.83822 0.223715 4.6579 4.31096 +434 4 51.8274 35.9658 0.402852 -15.0801 -2.53131 0.358002 +435 4 50.2142 36.8299 0.38331 4.02889 -26.7998 -2.47013 +436 4 50.6312 33.9821 1.2741 -7.74727 -6.99272 -14.4028 +437 4 50.1255 34.5169 41.5875 17.6482 -15.4813 7.31014 +438 4 49.2229 34.7469 0.909632 -22.6621 -5.40937 19.0501 +439 1 53.014 40.2496 6.3528 -7.33511 22.7823 24.6419 +440 2 53.0995 40.7279 7.73814 -49.8191 -29.044 -3.24915 +441 2 53.1557 0.329785 7.7965 36.8238 12.814 -39.8954 +442 3 52.5287 0.997511 8.60414 -15.9304 4.02299 13.5617 +443 4 53.7341 39.5741 6.15629 12.7417 -17.108 -13.0125 +444 4 52.0658 40.401 8.2322 35.0205 13.5384 -7.46142 +445 2 54.2887 40.0362 8.44194 -31.1952 -6.28028 37.9979 +446 4 54.3393 40.3597 9.51814 11.9598 15.0179 -15.3163 +447 4 0.207826 40.1934 7.85611 17.4499 5.7482 6.56468 +448 4 54.1321 38.9464 8.61757 0.233079 -2.0185 -17.8759 +449 1 53.9798 0.938968 6.8679 -0.195991 -19.5991 -5.8991 +450 2 54.0539 2.3703 6.69095 -13.0728 33.3033 12.6105 +451 2 52.7411 3.03405 6.19669 -13.7918 -57.342 -43.9621 +452 3 52.3429 4.1409 6.51048 0.805927 21.8583 24.6591 +453 4 54.6966 0.402301 6.30051 -22.9471 7.504 14.9388 +454 4 54.1387 2.85352 7.70963 6.90446 -7.48262 -5.16091 +455 2 0.230181 2.82991 5.77971 -8.39605 37.5401 -18.7849 +456 2 1.62806 2.36187 6.13631 43.8101 -17.859 13.5365 +457 2 2.01439 2.63812 7.6434 4.44409 -15.8917 -34.667 +458 2 3.251 1.82053 8.03886 10.3698 -25.435 21.3536 +459 1 3.78609 2.13458 9.37971 -1.03569 -21.7613 -70.4054 +460 4 0.236987 4.00662 5.72725 -0.841737 -32.3075 1.88093 +461 4 55.0233 2.47547 4.72977 -1.92078 4.0191 4.58104 +462 4 2.43886 2.84427 5.52141 -13.7997 6.98566 -1.14785 +463 4 1.8001 1.26942 5.8525 -13.1218 12.7308 11.199 +464 4 1.17734 2.2629 8.25415 -4.76662 9.03037 15.6753 +465 4 2.26439 3.72233 7.77766 -11.2971 -1.006 3.39024 +466 4 4.0605 1.91272 7.29579 6.96563 5.43042 -1.59904 +467 4 3.03028 0.709673 8.06144 -4.99399 12.6268 -3.20223 +468 4 3.89697 1.2978 9.90866 2.2165 -13.9672 17.3419 +469 4 3.11983 2.70535 9.83652 -2.18207 25.7622 26.4666 +470 4 4.71792 2.51816 9.23842 -3.78155 13.4581 18.6473 +471 1 52.0021 2.30339 5.27929 12.8772 20.7449 44.6796 +472 2 50.6928 2.72834 4.84618 -13.8318 -0.832969 -24.58 +473 2 49.579 2.58092 5.91693 0.565718 25.7533 -2.22664 +474 3 48.7752 3.51298 6.10069 9.60089 -13.9081 0.0850852 +475 4 52.4111 1.47967 4.84803 3.54375 -13.752 -6.04623 +476 4 50.7183 3.81521 4.5849 2.62435 0.742467 8.46338 +477 2 50.3339 2.0499 3.47904 12.4361 -26.7668 8.24264 +478 2 51.3981 2.34325 2.36407 -25.9391 22.844 -14.5031 +479 2 48.9153 2.37958 2.98651 -2.89914 40.9383 9.35249 +480 2 51.1891 1.41918 1.15407 38.5806 -15.4927 -30.3188 +481 4 50.4158 0.92469 3.65006 -8.90797 13.02 4.48026 +482 4 52.4055 2.20648 2.74929 18.7984 -5.45377 5.09466 +483 4 51.3666 3.42411 2.00589 -1.76359 -13.5005 7.53435 +484 4 48.1353 2.36077 3.79579 2.75746 -16.6411 -10.078 +485 4 48.6799 1.76326 2.11438 -14.9792 -11.0957 -5.84075 +486 4 48.8325 3.45193 2.63807 7.50371 -11.7896 -0.401559 +487 4 52.1004 1.43799 0.414216 -21.3416 1.39174 26.2203 +488 4 50.3409 1.68288 0.503068 -10.2032 3.93981 2.99084 +489 4 51.0565 0.33979 1.46483 1.72575 11.8892 -3.22767 +490 1 49.5807 1.53255 6.75244 19.5889 -24.3514 7.76629 +491 2 48.7262 1.39688 7.92951 3.12598 20.2674 -1.73108 +492 2 48.8873 2.63773 8.86406 -22.8968 -16.6402 -5.42224 +493 3 47.8891 3.05472 9.45614 -0.472007 6.27789 -5.95623 +494 4 50.2352 0.731103 6.58688 -10.8709 15.7502 1.66713 +495 4 47.6402 1.39986 7.60999 11.2933 -0.131061 -1.07735 +496 2 49.0614 0.0990051 8.70607 -29.9824 -25.1823 -11.7347 +497 2 48.2869 41.7602 10.01 13.4599 -0.122667 29.7563 +498 2 46.7828 0.0292377 10.0132 -0.929007 -24.4408 -23.1824 +499 3 46.2118 0.52149 10.9702 -12.9016 15.2185 13.9881 +500 1 46.1401 41.3429 8.96595 27.5879 22.2376 34.4467 +501 4 50.107 0.108866 8.97457 27.7162 -1.73681 3.74735 +502 4 48.8999 41.0818 8.03917 5.36927 20.2302 10.0129 +503 4 48.7183 0.460982 10.852 -8.35522 8.57003 -12.646 +504 4 48.4869 40.755 10.454 -1.65554 -4.90235 -14.5783 +505 4 46.6392 40.8985 8.22302 16.4703 -11.2583 -22.7525 +506 4 45.1487 41.2958 8.97726 -40.9601 -1.33251 0.190018 +507 1 50.0995 3.17318 9.05078 3.95851 -0.0485648 -3.79593 +508 2 50.3325 4.25644 9.97415 17.5873 21.0859 -2.62556 +509 2 49.9752 5.63804 9.37548 -18.0954 -29.5198 29.938 +510 3 49.379 6.45094 10.0988 9.73071 -4.74536 -2.58342 +511 4 50.9107 2.76055 8.59957 11.9693 -5.38147 -4.75744 +512 4 49.6509 4.09994 10.8399 -6.9467 2.38538 1.23714 +513 2 51.7744 4.26209 10.561 -12.6039 -21.2869 -0.279481 +514 2 51.8614 5.17465 11.7883 77.4573 -1.34868 -55.222 +515 3 50.9415 5.19238 12.5756 -62.6641 4.37367 45.7089 +516 3 52.9385 5.83334 11.9521 -15.5069 -3.45829 -0.856418 +517 4 52.5513 4.49045 9.80335 -1.41111 7.91559 -3.33271 +518 4 51.9847 3.17606 10.8252 3.56611 15.7947 8.37571 +519 1 50.1134 5.83384 8.05697 5.03044 -3.38183 -24.9476 +520 2 49.6949 7.07302 7.45907 -6.39224 21.6045 -14.6025 +521 2 48.2404 7.19765 6.96855 9.41443 -40.5535 -11.5325 +522 3 47.5994 8.23003 7.09737 -2.60339 17.4007 5.13595 +523 4 50.5903 5.18529 7.39903 -4.72806 0.48988 13.3104 +524 4 49.6568 7.79446 8.28532 6.84483 14.8177 6.93296 +525 2 50.7045 7.63108 6.39006 -19.8247 -9.47824 8.02755 +526 2 50.6996 6.84785 5.08902 -10.629 2.31661 -15.1243 +527 2 51.6586 7.26626 3.9659 -11.3496 43.5825 3.95364 +528 2 53.1317 7.00105 4.2557 32.8208 18.7244 -18.8206 +529 1 53.7683 7.95578 5.14747 -10.6729 7.59108 -11.9454 +530 4 51.7028 7.64661 6.81348 16.7201 -1.45014 11.0251 +531 4 50.4708 8.68128 6.19684 -5.34256 14.1207 -5.41714 +532 4 49.6713 6.8702 4.6668 -0.861277 1.74329 -1.61352 +533 4 50.8688 5.79892 5.31654 5.28855 -19.0543 2.54637 +534 4 51.4741 8.35024 3.65396 8.42695 -12.5098 16.2485 +535 4 51.3565 6.79125 3.04708 -1.5826 -26.0582 -19.3792 +536 4 53.7673 7.0998 3.31183 -20.6632 -9.77681 9.39502 +537 4 53.2972 5.98514 4.64126 3.7215 -8.75629 2.11801 +538 4 53.3251 8.87081 5.17658 4.71004 0.103302 -2.74719 +539 4 54.7439 8.12131 4.95956 10.0262 2.1061 -7.58392 +540 4 53.7752 7.60869 6.06781 -3.05466 -8.65204 35.212 +541 1 47.7159 6.1092 6.3306 31.3529 14.3598 14.0351 +542 2 46.4076 6.11425 5.7591 -25.7668 -19.0326 -13.8071 +543 2 45.4013 5.23171 6.47844 56.1675 -11.9112 16.6864 +544 3 44.23 5.34684 6.24133 -49.2229 2.39302 -4.99484 +545 4 48.3398 5.28969 6.15889 -17.2258 10.451 -1.21207 +546 4 45.9358 7.11624 5.83656 4.3919 7.44058 4.79016 +547 2 46.401 5.6982 4.25555 12.45 -16.5042 -24.1702 +548 2 46.8608 6.82251 3.28226 -4.83626 -15.1342 -13.4955 +549 2 46.0803 8.13881 3.30599 -14.5444 -4.79224 -13.1752 +550 3 44.9716 8.27119 2.67975 10.7775 -8.64163 7.28309 +551 3 46.5691 9.08454 3.95876 4.86602 16.815 8.62941 +552 4 45.3845 5.39013 3.90204 -1.72737 6.76951 8.44594 +553 4 47.0179 4.72632 4.06618 -9.2699 26.8442 8.77601 +554 4 46.8747 6.40942 2.20799 2.04532 8.89503 18.2744 +555 4 47.9008 7.08537 3.56457 7.18737 -1.18981 -5.53646 +556 1 45.8799 4.29222 7.33829 -37.7514 2.20406 -4.61566 +557 2 44.9987 3.41141 8.06424 -3.99299 1.7641 -5.76947 +558 2 44.3276 2.33248 7.21969 -45.1266 -42.7281 27.6017 +559 3 43.411 1.613 7.73718 25.6836 24.6852 -13.962 +560 4 46.8488 4.10168 7.49502 31.0353 -1.43619 1.82022 +561 4 45.5349 2.87862 8.87403 3.80662 2.65181 2.49747 +562 4 44.2009 4.01738 8.56522 2.51171 -3.43938 -1.53795 +563 1 44.7359 2.05713 5.97006 1.92732 3.23614 21.462 +564 2 44.1948 0.978467 5.13766 -26.7101 17.135 -13.9432 +565 2 44.8486 41.5478 5.5025 3.41127 -20.6454 16.5554 +566 3 46.0871 41.4431 5.57675 -14.0525 11.0231 2.35631 +567 4 45.5581 2.59183 5.73006 15.6975 -3.64086 -27.3416 +568 4 43.0338 0.980574 5.28193 28.569 -9.56263 1.83686 +569 2 44.4255 1.37435 3.62453 6.02041 -5.1027 -4.41971 +570 2 43.5303 2.62118 3.29791 4.64703 16.7196 -23.7169 +571 2 44.2051 0.148173 2.67978 -29.1583 2.83252 11.5038 +572 2 43.5747 3.10962 1.83395 1.21002 2.08355 -6.515 +573 4 45.4937 1.66977 3.44724 -0.165314 0.952935 9.41179 +574 4 43.8006 3.52551 3.92139 -2.56937 -12.5949 1.07415 +575 4 42.4611 2.43664 3.46298 -10.2855 -9.14552 12.9963 +576 4 44.5119 0.377143 1.64896 8.27723 -0.881131 -7.54742 +577 4 43.1044 41.7625 2.59144 16.8524 3.81389 6.96191 +578 4 44.7846 41.171 3.05101 -3.46686 1.83863 -12.0461 +579 4 44.5392 3.56167 1.57116 9.55733 8.13116 4.62467 +580 4 42.7809 3.86627 1.57982 6.14378 -4.69974 7.81616 +581 4 43.4757 2.31615 1.08375 -8.22918 -11.6964 -1.57482 +582 1 44.0839 40.4233 5.76821 21.932 -1.5334 -8.86254 +583 2 44.7424 39.1674 6.24443 -3.28027 29.5462 -2.23354 +584 2 45.6232 38.4648 5.15467 16.5957 -3.17533 31.1682 +585 3 45.1655 38.1269 4.0769 -9.06079 2.14789 -9.97198 +586 4 45.3594 39.5074 7.13461 -7.15079 -15.4686 -7.49065 +587 2 43.5266 38.3049 6.70081 12.2837 2.36218 -7.01546 +588 2 42.3912 38.8204 5.83129 -5.25874 0.19697 14.2242 +589 2 42.6515 40.3318 5.90174 -25.8883 17.7161 37.6601 +590 4 43.2615 38.5482 7.76954 6.63706 -13.879 -3.94164 +591 4 43.7406 37.2122 6.50504 -6.24398 7.50926 12.4246 +592 4 41.3856 38.4747 6.1895 5.24712 7.09666 -1.13826 +593 4 42.5101 38.4102 4.83081 -0.0162975 -1.57753 -20.806 +594 4 42.2783 40.7857 6.94925 18.7272 -16.9878 -38.5107 +595 4 42.0764 40.8825 5.13323 2.00122 -0.967094 -8.03005 +596 1 46.8623 38.0021 5.57674 -15.3549 -23.0767 -9.82664 +597 2 47.7161 37.0187 4.84527 -3.88045 42.2808 23.2471 +598 2 47.0384 35.8723 4.15029 10.1677 -9.37304 -39.3599 +599 3 47.4551 35.4743 3.0324 -9.4669 19.846 29.5852 +600 4 48.2252 37.6386 4.0698 7.54977 -11.2433 -2.33648 +601 2 48.6452 36.5035 5.99482 -10.0312 13.1223 -5.95218 +602 2 48.8959 37.7819 6.80046 -4.41071 -5.72741 24.5975 +603 2 47.4918 38.4151 6.80561 23.284 1.3706 -4.72721 +604 4 49.5844 36.0861 5.59811 5.91725 -9.04521 -0.913385 +605 4 48.1158 35.748 6.64071 6.83063 -0.71303 -5.46675 +606 4 49.6383 38.4449 6.34864 7.02588 7.83512 -10.7506 +607 4 49.3019 37.5753 7.85532 -11.9914 1.76609 -18.7023 +608 4 47.544 39.5162 6.85821 3.72706 6.34433 1.60956 +609 4 46.9486 38.0654 7.68542 -11.5693 -5.06488 12.3189 +610 1 46.0019 35.318 4.78064 -26.4221 -3.88232 27.7903 +611 2 45.3025 34.13 4.26579 26.8092 19.3149 11.5505 +612 2 44.4585 34.46 3.02929 16.6723 1.23881 35.6677 +613 3 44.3932 33.6565 2.12406 -6.96945 -13.3218 -23.6344 +614 4 45.6895 35.6839 5.72645 6.17072 -11.3773 -21.4598 +615 4 46.1371 33.4525 3.9443 -9.57056 -4.48549 -9.01935 +616 2 44.5851 33.4333 5.41517 7.28023 -34.3989 -9.31284 +617 2 43.896 32.1478 4.95943 -2.5072 53.7563 23.2534 +618 3 42.6929 32.0377 5.28407 -11.6877 -17.8688 -5.68187 +619 3 44.6212 31.2997 4.42805 15.8429 -32.9345 -13.4225 +620 4 43.8908 34.1037 5.87793 -28.8167 18.0933 10.1447 +621 4 45.2673 33.1449 6.25678 1.67129 3.14432 -6.05002 +622 1 43.9425 35.6996 2.93756 -0.354949 -32.7532 -51.8723 +623 2 43.3733 36.2033 1.70184 -38.6892 -13.1006 14.7431 +624 2 44.3694 36.8017 0.73913 15.0439 4.82349 -39.1461 +625 3 44.0609 36.9601 41.4463 -0.757384 -5.0254 19.6545 +626 4 44.0082 36.3398 3.67638 4.88567 37.3717 42.7902 +627 4 42.8639 35.3314 1.17484 15.8753 7.76257 0.915116 +628 2 42.1931 37.1947 1.98861 35.687 20.598 -23.7763 +629 2 41.116 36.6037 2.88066 -6.28281 10.7168 27.7809 +630 2 39.8788 37.4748 2.97821 -20.6793 -12.2331 -39.8799 +631 3 39.5744 38.0012 4.02693 -4.5695 14.1805 28.3661 +632 1 39.0796 37.534 1.86047 23.989 -9.69865 9.57867 +633 4 41.7899 37.5369 1.00167 -6.59533 -6.76427 4.06671 +634 4 42.6371 38.1477 2.39011 -7.96796 -7.2267 7.32793 +635 4 41.4745 36.4913 3.95075 -0.75248 -0.913082 -13.6466 +636 4 40.7949 35.61 2.55083 -3.16107 -12.1939 -5.02302 +637 4 39.3636 37.1043 0.951835 -4.89499 3.13933 11.6446 +638 4 38.1602 37.9899 1.92801 1.07188 2.17452 -2.18356 +639 1 45.5977 37.1878 1.1702 -15.0402 3.91697 -26.2999 +640 2 46.6124 37.7593 0.269692 0.961344 -25.1749 -6.20454 +641 2 47.1251 36.6298 41.227 -15.6894 27.1972 18.7996 +642 3 47.6617 35.6605 41.7393 11.2436 -21.3221 -9.23089 +643 4 45.7953 37.0706 2.14421 15.4189 2.49224 25.3654 +644 4 46.1246 38.4981 41.5406 -7.74237 14.7139 -7.84953 +645 2 47.8075 38.4099 1.03092 10.1012 15.6193 -18.1996 +646 2 47.4246 39.6903 1.82563 -12.4684 -22.6418 23.6998 +647 2 48.6005 40.4099 2.51691 -17.3417 -7.9082 6.23218 +648 3 49.6876 40.5582 1.97833 4.99301 -0.872474 -9.60266 +649 1 48.339 40.8761 3.75079 34.2245 13.1834 24.2049 +650 4 48.6123 38.7237 0.293834 -9.9427 -4.45455 6.13719 +651 4 48.2879 37.6501 1.66455 2.7768 -3.8165 9.90104 +652 4 46.6323 39.34 2.60232 21.0344 18.1725 -15.5096 +653 4 46.9544 40.4315 1.1644 -6.65764 6.44375 -5.56957 +654 4 47.4103 40.9551 4.17425 -6.86232 -2.61251 -1.04516 +655 4 49.1568 41.2536 4.3255 -23.3959 -10.5461 -18.532 +656 1 47.0132 36.8194 39.8944 4.79393 -10.5252 -5.84263 +657 2 47.6604 36.043 38.8342 19.1375 -30.0942 8.85154 +658 2 48.4687 37.0132 37.9763 6.82075 18.1877 -22.3602 +659 3 47.9595 37.6039 37.0009 8.77071 -9.81154 18.2462 +660 4 46.405 37.5569 39.5258 -2.34297 5.9549 -2.23138 +661 4 48.4229 35.2731 39.2798 -19.3933 25.0679 -4.92238 +662 2 46.6775 35.1997 37.9517 0.490197 24.678 -10.7229 +663 2 46.0672 34.0096 38.7198 -38.9175 -0.700818 10.3629 +664 2 46.8744 32.685 38.9073 -3.26917 9.79703 -36.9848 +665 1 47.7628 32.6295 40.0786 -15.9706 28.2316 14.6984 +666 2 48.51 31.5331 40.3435 -4.63001 14.745 41.8738 +667 1 48.7312 30.5422 39.5064 -7.34995 -4.23697 -9.55446 +668 1 48.9018 31.3819 41.635 -19.9532 28.2508 -37.0556 +669 4 47.1729 34.8887 37.0027 6.80802 -10.5296 7.48075 +670 4 45.9076 35.9114 37.5121 1.10402 -9.8189 16.5264 +671 4 45.0997 33.7597 38.1755 17.1722 -3.36537 -3.11703 +672 4 45.6001 34.3514 39.6854 13.8349 -0.884929 -1.62484 +673 4 47.4022 32.4647 37.9216 2.87405 7.70981 18.3952 +674 4 46.1271 31.862 38.9206 0.553217 -4.0431 12.8995 +675 4 47.6279 33.4362 40.8042 9.43822 -37.2826 -24.9694 +676 4 48.3342 30.5657 38.5603 0.826291 -3.97588 -2.82687 +677 4 49.185 29.675 39.7859 6.04467 -9.07236 4.91997 +678 4 48.5432 32.0104 0.443983 -2.47374 7.53927 7.97734 +679 4 49.3442 30.5519 41.958 17.8055 -32.7958 11.0172 +680 1 49.7507 37.2761 38.36 -27.9891 3.94923 -10.3626 +681 2 50.6372 38.1716 37.6465 6.90802 9.01894 -16.7299 +682 2 51.1009 37.4739 36.3314 6.00851 -0.000986305 0.302592 +683 3 51.4496 36.2941 36.3505 -3.04594 -4.29189 2.8804 +684 4 50.1774 36.6397 39.0138 14.1864 -12.0724 14.4781 +685 4 50.0595 39.0583 37.2837 -1.51256 1.6517 8.14679 +686 2 51.8464 38.6091 38.5553 2.49074 0.426256 -22.3009 +687 2 51.5192 39.49 39.8069 -13.5557 -5.73698 -8.16935 +688 2 52.7888 39.6608 40.6664 -21 22.821 44.9745 +689 2 51.0354 40.8913 39.3667 -19.684 19.0705 -14.0846 +690 4 52.5817 39.1556 37.8894 -7.88883 -2.40182 8.97054 +691 4 52.3725 37.6699 38.8321 2.26719 1.04002 8.03718 +692 4 50.6848 39.0041 40.3963 9.50705 2.70236 -0.692257 +693 4 52.9505 38.8088 41.3668 0.716139 -3.31122 -6.89789 +694 4 52.7117 40.5855 41.3722 -1.5977 -23.2904 -18.3054 +695 4 53.6872 39.819 40.0903 21.6097 1.4026 -14.7648 +696 4 51.7777 41.4333 38.7338 5.73144 0.910017 10.7761 +697 4 50.6933 41.5309 40.2327 12.7628 -5.43827 -4.45399 +698 4 50.1361 40.9136 38.7005 3.06807 -14.6998 5.44273 +699 1 51.1637 38.2069 35.1833 -8.65277 46.2898 44.1617 +700 2 51.553 37.7419 33.8846 1.56046 15.8517 -26.9219 +701 2 52.7972 38.5563 33.3946 6.24297 -42.3048 -4.64985 +702 3 52.8896 39.7642 33.5814 -6.435 17.9384 2.35192 +703 4 50.9569 39.2647 35.262 8.21378 -41.2603 -12.3383 +704 4 51.8027 36.6701 33.8819 4.46523 -10.0245 6.73196 +705 2 50.2986 37.9511 32.9329 -9.17145 -5.64023 18.3882 +706 2 49.0629 37.0889 33.4059 8.5101 -2.50878 -15.0431 +707 2 50.6601 37.6697 31.4816 -9.00198 -6.28682 -34.5666 +708 2 49.2037 35.5513 33.2317 13.0867 -6.63955 11.9256 +709 4 49.9372 39.0006 33.0238 8.27291 6.69816 -3.39278 +710 4 48.1686 37.4323 32.8001 8.11156 -5.69031 9.58675 +711 4 48.8477 37.3684 34.464 -5.28515 -5.82898 -0.156702 +712 4 49.7508 37.5287 30.8047 12.011 -0.0430796 16.0089 +713 4 51.2928 36.7446 31.376 -4.11156 8.47591 0.32382 +714 4 51.1768 38.5507 31.0175 4.51478 -6.96789 5.36543 +715 4 50.1453 35.1216 33.7014 -11.0082 12.206 -5.4516 +716 4 49.2178 35.23 32.1578 -3.59036 3.22922 4.55632 +717 4 48.3665 35.0295 33.7638 0.68062 2.42879 -7.65558 +718 1 53.772 37.8505 32.7005 11.9802 38.3584 -9.99311 +719 2 54.8892 38.4918 31.9453 -18.9337 33.3604 36.4373 +720 2 0.0457823 37.9282 30.5422 -8.24024 2.92716 -24.5162 +721 3 0.594264 36.8423 30.3259 -11.3073 1.50903 5.31397 +722 4 53.7906 36.8495 32.616 -6.44893 -30.0966 2.1434 +723 4 54.5933 39.6185 31.9763 4.67753 -27.1194 -20.6963 +724 2 1.30394 38.4484 32.6241 4.82921 -5.73508 14.5601 +725 2 2.2605 39.423 31.9346 -38.1373 19.2777 23.8899 +726 2 1.83713 40.7771 31.9484 17.1926 2.24265 -1.86924 +727 2 3.4991 39.1266 31.4137 44.2785 -3.28979 -22.8275 +728 2 2.64242 41.8019 31.4282 -29.5168 1.86603 13.0701 +729 2 4.3212 40.1796 30.8558 3.27898 -39.2743 8.81887 +730 2 3.87185 41.4777 30.8782 6.24363 43.3598 -8.15054 +731 4 1.73925 37.4095 32.5315 -6.00214 7.91305 5.68876 +732 4 1.22265 38.7505 33.7444 5.52003 -9.57077 -28.715 +733 4 0.900292 41.0813 32.4345 -2.25415 1.01323 1.36593 +734 4 3.85804 38.0586 31.4239 -1.87041 17.6471 -1.97414 +735 4 2.21075 0.929728 31.5263 16.6224 -11.4708 -8.14622 +736 4 5.34427 40.0148 30.4252 -14.7168 -7.47964 5.81345 +737 4 4.49601 0.410438 30.4759 -4.95559 -13.7664 3.94973 +738 1 54.5157 38.6773 29.5249 -27.0888 35.6462 7.20647 +739 2 54.4663 38.361 28.1069 5.2815 -2.56059 -27.0064 +740 2 53.8105 37.007 27.8285 4.1142 -30.4598 -15.4676 +741 3 54.2925 36.1623 27.0158 -8.84 24.3654 24.6709 +742 4 54.0165 39.6075 29.7175 18.6271 -30.7219 2.56864 +743 4 53.83 39.1099 27.5328 0.819814 -7.88342 20.1611 +744 2 0.845681 38.4599 27.4009 -3.37868 13.1124 0.920574 +745 4 1.3644 39.4179 27.7359 0.635395 -16.0183 -8.53916 +746 4 0.720089 38.4757 26.2839 -0.330424 7.67272 7.0695 +747 4 1.43916 37.5478 27.5772 11.0328 -1.07232 10.5421 +748 1 52.6562 36.7643 28.4919 4.43857 42.1876 29.7882 +749 2 51.8688 35.5726 28.5678 11.3762 10.3615 -9.24037 +750 2 52.1836 34.677 29.7554 -56.6515 -45.7393 26.8579 +751 3 51.2796 33.8674 30.1477 33.9368 21.5747 -13.7315 +752 4 52.2409 37.5914 29.034 7.3769 -32.5773 -16.326 +753 4 50.8037 35.9045 28.6197 0.824464 -11.9292 4.40922 +754 4 51.9818 34.9789 27.6186 -1.74208 2.17118 9.08886 +755 1 53.386 34.609 30.3327 15.9463 0.295407 3.2668 +756 2 53.8702 33.5918 31.2906 -5.336 7.3854 -1.97925 +757 2 53.2724 33.784 32.6972 3.62039 -3.18208 -20.5224 +758 3 53.318 34.8834 33.2435 -3.37109 6.20646 2.08258 +759 4 54.0584 35.341 30.1321 12.3398 9.17802 -3.54281 +760 4 53.5469 32.5903 30.928 0.510164 -2.93777 -2.78072 +761 2 0.450375 33.6574 31.3834 -19.8167 20.6669 9.28695 +762 2 1.1189 33.1041 30.1021 -5.33927 -7.82927 4.13606 +763 2 2.62926 33.3565 30.0201 27.5042 -3.46073 -5.185 +764 2 3.52676 32.4236 30.898 -7.76336 10.6891 3.26174 +765 1 4.93921 32.7908 30.8651 -15.3408 -23.1293 6.29736 +766 4 0.715906 33.1135 32.3077 13.219 -7.49284 0.339296 +767 4 0.711888 34.7596 31.5921 3.25804 -21.2431 -6.20467 +768 4 0.610971 33.6189 29.2485 6.53106 -4.93764 -4.86032 +769 4 0.94328 31.9817 29.9891 -3.372 16.4508 0.497364 +770 4 2.92569 34.3879 30.2717 -10.3735 11.8265 3.32189 +771 4 2.96748 33.277 28.9434 -5.36763 -4.46501 9.75656 +772 4 3.3856 31.3899 30.5364 6.91643 -9.08032 2.48396 +773 4 3.23325 32.4634 31.9813 -4.58699 -1.94284 -9.93441 +774 4 5.35439 32.7181 29.9584 6.30767 5.94328 -10.9381 +775 4 5.52691 32.2429 31.4849 -0.455553 -3.36681 1.56927 +776 4 5.05493 33.7218 31.1915 7.72328 25.1707 0.250012 +777 1 52.7526 32.6794 33.2917 -1.1678 -10.0217 7.16811 +778 2 52.3607 32.6823 34.7156 1.10255 -1.80451 -46.4405 +779 2 53.6298 32.9771 35.466 24.3124 -3.86391 3.03884 +780 3 54.7252 32.4235 35.2212 -23.0397 10.722 4.71956 +781 4 52.6718 31.7771 32.7765 -0.499018 10.5241 3.64804 +782 4 51.648 33.5318 34.8013 -6.43996 -0.39665 8.9378 +783 2 51.7643 31.3153 35.1205 -14.6608 -0.598675 31.299 +784 2 50.4472 31.4454 35.9643 8.77941 -15.5352 -26.1807 +785 2 50.5832 31.9625 37.3651 -2.67912 16.3525 37.5763 +786 3 49.9209 32.9494 37.7433 9.07957 -2.58057 -6.15032 +787 1 51.437 31.3297 38.2211 2.67596 1.57171 0.930055 +788 4 52.5216 30.7277 35.7054 -4.20254 0.0350677 -4.46682 +789 4 51.4878 30.6783 34.2719 3.29993 -4.42069 -15.0162 +790 4 49.9434 30.4567 35.9623 3.78404 -4.63917 10.5702 +791 4 49.6858 32.0412 35.427 2.21977 11.0074 -1.38139 +792 4 51.8063 30.3924 37.9705 2.16328 6.00798 1.3625 +793 4 51.6437 31.7399 39.1747 -6.68696 -10.5036 -22.3596 +794 1 53.5095 33.8962 36.42 -8.20166 25.4414 22.1973 +795 2 54.5747 34.3024 37.3295 -19.3274 -47.2338 19.7644 +796 2 54.3374 33.5175 38.6424 -52.3016 59.5202 -10.0971 +797 3 53.3688 33.7998 39.3891 18.863 -9.21915 -6.06634 +798 4 52.6243 34.4292 36.5865 8.7567 -9.68897 -5.69769 +799 4 0.524888 33.8606 36.995 20.2449 10.0463 -17.6441 +800 2 54.6326 35.7977 37.4305 -12.9517 47.1344 28.5316 +801 2 0.0326923 36.4499 36.0829 -2.43572 -2.53932 -10.8482 +802 2 0.0400304 37.9734 36.2703 -35.7369 26.7596 -9.32276 +803 2 1.42323 35.9178 35.6511 7.48175 21.564 37.2538 +804 4 0.37702 36.205 38.1946 -7.23177 -18.0499 -4.52301 +805 4 53.6103 36.1739 37.8346 22.3749 -7.86488 -15.795 +806 4 54.308 36.1878 35.2646 -5.73883 1.17112 4.65385 +807 4 54.1487 38.389 36.8719 12.989 -15.5349 -14.8375 +808 4 55.0091 38.5546 35.2982 1.66458 -12.2972 11.8538 +809 4 0.898146 38.314 36.8215 26.4509 7.27198 12.604 +810 4 1.38795 34.9003 35.2548 1.76467 -17.1685 3.06812 +811 4 2.15782 36.0461 36.5409 -11.2535 -11.763 -23.0993 +812 4 1.84494 36.4876 34.8385 7.70144 16.3511 -18.9114 +813 1 0.00368541 32.3928 38.6933 60.3495 -72.1401 -12.2197 +814 2 54.849 31.2911 39.6724 -12.054 11.0917 -33.5573 +815 2 0.456178 31.7903 40.9874 10.6429 2.84259 -7.8967 +816 3 1.61925 32.1816 41.0469 -1.25889 2.69502 -0.320895 +817 4 0.771148 32.2113 37.9508 -27.5595 2.34137 31.2634 +818 4 53.7516 31.0568 39.7052 4.35339 2.80588 13.4321 +819 2 0.572301 30.0297 39.0906 18.5839 -9.3637 1.30639 +820 2 0.330271 28.7129 39.848 -4.85336 -14.889 23.6916 +821 2 0.693398 28.6486 41.365 -25.7394 -2.5332 -16.7842 +822 3 54.7394 28.745 0.295995 1.88939 6.38348 7.55667 +823 3 1.88537 28.4667 41.718 12.1129 0.623711 3.73015 +824 4 1.68124 30.2872 39.0755 -12.926 -11.288 -1.20667 +825 4 0.269733 29.7427 38.025 4.32739 20.9521 12.5377 +826 4 0.909417 27.8521 39.409 -5.73579 9.2082 -7.491 +827 4 54.2152 28.4395 39.7334 16.9231 1.48772 2.1114 +828 1 54.6305 31.7883 0.132952 22.8608 6.07746 39.2243 +829 2 54.8576 32.3299 1.48573 -29.3221 31.1311 -21.4901 +830 2 1.17253 32.0229 2.2009 17.6366 -16.111 10.5973 +831 3 1.59057 32.8071 3.07156 -0.674056 0.0659302 -13.788 +832 4 53.659 31.6017 41.9208 -28.5726 -8.3455 -12.917 +833 4 54.8441 33.4787 1.30532 5.06012 -29.8204 14.0187 +834 2 53.6539 32.0394 2.47663 -0.820586 10.1398 -23.6755 +835 2 52.2239 32.3686 2.01123 21.8921 -9.62397 -13.268 +836 3 51.4302 33.0165 2.73635 3.85378 3.64717 10.9914 +837 3 51.8951 32.0293 0.84168 -3.94391 -2.23918 -4.0609 +838 4 53.7898 32.6162 3.39279 8.30271 4.42614 18.4259 +839 4 53.7249 30.9715 2.71423 -6.48233 -12.4206 11.3701 +840 1 1.80027 30.8157 2.00429 -3.41308 17.021 -11.1273 +841 2 3.01391 30.3872 2.67306 -17.4243 6.23421 51.1709 +842 2 4.3573 30.5827 2.00701 -14.1548 15.4243 -63.5733 +843 3 5.42088 30.6338 2.61698 6.51202 -0.211014 15.7475 +844 4 1.38736 30.0831 1.41283 -0.948729 3.54349 -2.60962 +845 4 3.08525 30.9412 3.69277 -1.85342 -9.762 -26.0847 +846 4 2.85031 29.3254 2.98975 11.9317 8.24793 -5.27874 +847 1 4.28888 30.743 0.620497 -12.3621 7.32386 22.4338 +848 2 5.32937 31.2764 41.6512 -13.8663 -29.5394 -9.66616 +849 2 5.57121 32.722 0.10225 -38.3787 16.5244 28.1783 +850 3 4.67744 33.4061 0.685107 26.0808 -18.0695 -15.0621 +851 4 3.36015 30.6914 0.159011 7.3551 0.286523 4.85155 +852 4 6.25759 30.6643 41.7722 1.97617 9.44883 5.82281 +853 2 4.84937 31.1813 40.1487 29.2597 0.863212 8.06821 +854 2 4.69879 29.8019 39.4857 10.4894 -21.0831 -13.1113 +855 2 5.6473 28.6668 39.9936 -13.3021 -14.9024 -16.8737 +856 1 5.27077 28.179 41.3306 -2.96519 4.49812 -11.7353 +857 2 6.06985 28.0105 0.470368 18.4061 -2.74343 27.4639 +858 1 7.404 28.2193 0.415809 -33.9112 -6.97322 0.0250223 +859 1 5.53751 27.6715 1.66745 7.41355 -4.5447 5.6764 +860 4 5.59287 31.7875 39.5584 -6.62026 -5.01092 -0.797873 +861 4 3.90042 31.6963 40.0361 -18.37 16.2558 -2.13315 +862 4 4.87993 29.9347 38.3602 -5.0628 -2.10161 17.6043 +863 4 3.66163 29.4121 39.5629 -5.01534 4.60088 1.06729 +864 4 6.67981 29.0441 39.9161 8.56645 -0.645935 3.00783 +865 4 5.57604 27.7587 39.2774 2.4211 23.1794 17.5601 +866 4 4.26853 28.0084 41.463 -5.17362 0.488763 -0.181308 +867 4 7.82192 28.2777 41.397 19.0269 3.46358 -1.03101 +868 4 7.9555 28.2212 1.28205 9.21585 -1.90571 -0.36079 +869 4 4.50489 27.4888 1.75639 19.7441 2.64647 4.92685 +870 4 6.15841 27.5559 2.53009 -21.7479 0.642981 -21.0512 +871 1 6.76075 33.214 41.6912 19.219 -12.8447 -16.8584 +872 2 7.12868 34.5749 41.8436 1.78261 35.3429 43.0116 +873 2 6.77609 35.3298 40.5962 -19.1975 -45.9981 -46.2181 +874 3 6.48326 34.7082 39.534 6.6414 26.9902 28.4778 +875 4 7.37626 32.7254 41.0127 -5.73863 2.32833 8.30529 +876 4 6.55071 35.0559 0.812315 8.37617 -12.7412 -20.2377 +877 2 8.6392 34.7953 0.238234 19.5739 7.90851 -48.6006 +878 3 9.35353 34.1854 41.0304 -12.8386 -4.95727 8.3137 +879 2 9.11551 34.1669 1.50873 -18.8724 -23.6236 42.9663 +880 4 8.9088 35.8955 0.234805 -6.25165 -9.40588 3.92441 +881 4 10.2786 34.3917 40.988 -0.40493 9.85267 11.4657 +882 4 10.1184 34.4515 1.79035 25.1513 6.04912 0.147779 +883 4 9.07131 33.0605 1.52977 2.37755 -2.72972 -9.56943 +884 4 8.50911 34.4369 2.41136 -0.948376 7.25744 -9.18832 +885 1 6.94474 36.6394 40.6556 -2.44135 26.6434 -23.8261 +886 2 6.9184 37.5467 39.5347 6.69905 -14.1713 -12.8446 +887 2 8.05389 37.1964 38.5245 -27.4859 18.9986 34.7956 +888 3 7.86013 37.2053 37.325 -9.29767 -2.30205 -27.2404 +889 4 7.0965 37.1097 41.5252 4.96112 6.67936 34.6112 +890 4 5.99819 37.3272 38.9586 -4.63141 4.06603 -3.57729 +891 2 6.96111 39.0217 40.0249 7.60343 4.99798 32.9439 +892 2 5.64771 39.5459 40.7503 13.3303 -11.7686 1.87571 +893 2 5.75985 41.0532 41.0609 20.2812 5.99168 -41.4278 +894 2 4.32816 39.2726 39.9704 18.565 3.35099 -29.4893 +895 4 7.21258 39.6788 39.2071 1.58444 12.8598 -26.2647 +896 4 7.87294 39.1662 40.7418 -24.807 -6.41168 -15.2883 +897 4 5.6203 39.0148 41.7319 -7.34537 -3.15131 1.25362 +898 4 4.91646 41.4032 41.6252 -26.0876 7.76092 9.54018 +899 4 5.84653 41.6805 40.0749 -1.44823 -14.0856 28.5036 +900 4 6.60816 41.2866 41.7276 9.52725 -0.69638 -3.08419 +901 4 4.29893 39.8385 38.99 0.215491 -3.12837 12.3269 +902 4 3.42741 39.5069 40.5265 -12.1672 8.54215 8.82184 +903 4 4.17367 38.2217 39.6869 7.24572 -5.84244 0.858739 +904 1 9.22626 36.8637 39.0427 21.4973 3.37181 48.1033 +905 2 10.3674 36.5714 38.2232 -9.10154 -9.23991 0.387697 +906 2 10.2983 35.2598 37.4643 -7.87493 -21.516 -1.82692 +907 3 11.0121 35.0941 36.4546 -10.096 5.18496 3.08952 +908 4 9.43559 37.0753 40.0799 -6.60045 -9.32212 -38.2223 +909 4 10.38 37.3229 37.4195 5.65865 10.6121 -8.5187 +910 2 11.637 36.6734 39.0312 17.5501 -7.37692 6.57672 +911 3 11.6795 35.7227 40.1079 -2.8679 20.1807 -0.19791 +912 4 11.748 37.6704 39.4409 -4.03165 17.0402 13.6797 +913 4 12.5247 36.6276 38.381 6.78129 -14.3562 -2.26856 +914 4 12.1944 34.9922 39.8075 10.5839 -13.8343 -8.97123 +915 1 9.37599 34.317 37.8723 17.0981 22.6825 36.4547 +916 2 9.03961 33.1663 37.0884 -21.5177 -32.5135 -8.8238 +917 2 8.42186 33.6216 35.772 12.1136 -61.8885 -37.6156 +918 3 8.46238 32.81 34.7849 1.32901 29.1307 35.9822 +919 4 8.95542 34.3811 38.853 10.4706 -4.46378 -29.0763 +920 4 9.93142 32.5518 36.7616 2.79547 16.9463 9.21372 +921 2 8.03197 32.1466 37.7484 3.42637 10.6841 -18.9321 +922 2 8.64707 31.2467 38.7916 -6.9544 1.67927 -4.64681 +923 3 8.29676 31.4213 39.9815 6.74685 -6.11142 9.13282 +924 3 9.44706 30.3423 38.4151 3.7337 3.36295 -6.87259 +925 4 7.50152 31.5448 36.9637 8.39997 -2.11551 6.41653 +926 4 7.19405 32.7023 38.1775 -8.25993 10.1263 10.5291 +927 1 7.75009 34.762 35.719 -22.4701 19.7147 -23.1057 +928 2 7.04455 35.3131 34.5484 -10.1936 -29.3849 23.8741 +929 2 7.86233 36.3488 33.8376 -13.0656 11.1044 -41.9487 +930 3 7.58485 36.6599 32.6528 -2.0293 -9.17756 21.4272 +931 4 7.63327 35.3235 36.5488 -2.91413 9.03335 17.0933 +932 4 6.86396 34.4501 33.8456 12.5342 10.3996 -5.08052 +933 2 5.61426 35.844 34.9306 19.6262 -1.52617 -28.8748 +934 2 4.83213 34.6653 35.4025 -10.2806 -24.7237 17.6593 +935 2 4.57558 34.457 36.7787 11.017 23.715 -9.65022 +936 2 4.42364 33.669 34.4835 -0.204454 17.9401 5.69744 +937 2 3.80293 33.3928 37.1817 -18.0339 -16.5573 23.9014 +938 2 3.6203 32.6104 34.8697 -1.59657 -1.57291 16.7967 +939 2 3.28719 32.4878 36.2185 14.3191 25.239 16.785 +940 3 2.42643 31.5967 36.7004 -21.786 -29.0921 6.36516 +941 4 5.08947 36.2348 33.9913 8.47084 3.13833 18.0937 +942 4 5.68856 36.6154 35.7126 -3.45102 11.3715 1.65586 +943 4 4.93536 35.177 37.5545 -2.85956 -5.82375 -8.46254 +944 4 4.68581 33.7849 33.4351 -1.13786 -0.0334624 -10.731 +945 4 3.5508 33.3312 38.3093 3.7661 -3.16504 -32.8067 +946 4 3.21561 31.8879 34.1609 -1.14089 -4.88721 -7.16666 +947 4 2.07822 31.0058 36.0335 4.80509 5.07869 -1.12919 +948 1 8.89276 36.9109 34.4697 3.08208 2.61779 2.42454 +949 2 9.71554 37.9518 33.9536 6.78836 41.9101 -7.41895 +950 2 8.87118 39.1918 33.5791 -2.83098 -3.29658 16.5328 +951 3 9.07345 39.7706 32.5156 6.00915 0.294316 2.75033 +952 4 9.0886 36.6939 35.4314 3.3626 -5.13227 22.9354 +953 4 10.4005 38.393 34.7625 -11.752 -18.5108 -5.62727 +954 2 10.5665 37.5273 32.7526 17.9231 -22.0125 -23.4044 +955 2 11.7038 38.502 32.4536 -20.96 9.74481 -37.2535 +956 3 11.6878 39.1949 31.3977 0.540028 -8.54016 25.273 +957 1 12.687 38.5377 33.3475 38.0496 20.2334 23.5086 +958 4 9.97947 37.4403 31.7814 1.01798 2.165 18.3599 +959 4 11.0193 36.505 32.8955 -2.74071 8.1052 0.988861 +960 4 12.6531 37.864 34.1655 7.32082 17.5294 -13.3715 +961 4 13.4532 39.3055 33.2787 -30.6572 -33.7139 4.421 +962 1 7.93658 39.5767 34.4996 32.6534 -23.6413 -9.43678 +963 2 7.20273 40.8089 34.5743 -2.74612 21.1773 -15.346 +964 2 8.21766 41.8982 34.9197 -3.45605 -13.7782 10.2915 +965 3 8.98784 41.7778 35.8832 -3.40272 -3.46005 -6.10842 +966 4 7.93188 38.9898 35.3424 -7.46187 6.56739 7.86278 +967 4 6.79415 41.087 33.5295 1.97546 -9.26453 20.6229 +968 2 6.06472 40.6271 35.6481 -5.08297 -2.08213 -22.9213 +969 2 4.90833 39.9858 34.8157 -12.6977 -10.7104 -3.72739 +970 2 5.64222 41.9226 36.403 -2.05312 -2.0705 -19.9517 +971 2 3.84054 39.2603 35.6406 -0.0147652 -3.33058 30.6695 +972 4 6.3943 39.8459 36.3734 2.85979 7.06395 10.3389 +973 4 5.33061 39.1839 34.1245 -4.62997 12.2623 4.99778 +974 4 4.37584 40.73 34.1591 8.26763 -2.20969 2.2716 +975 4 4.92993 41.6478 37.2106 -0.0042749 6.0371 4.19307 +976 4 5.15795 0.778755 35.7389 -1.27911 -10.984 2.34352 +977 4 6.51935 0.549814 36.8166 0.412823 -4.00159 10.9885 +978 4 3.21428 39.9846 36.2492 8.55414 -9.22464 -7.99451 +979 4 4.28582 38.4972 36.3757 -6.36125 15.4526 -14.7269 +980 4 3.14756 38.696 34.9847 -1.95473 -0.292674 -1.44435 +981 1 8.25206 1.08297 34.1638 31.3741 38.5442 9.59718 +982 2 9.18814 2.19093 34.4552 -11.7272 -14.356 -0.722089 +983 2 8.45749 3.48131 34.8023 4.76941 7.21795 3.77261 +984 3 7.24176 3.59586 34.6101 4.23254 1.41941 3.46139 +985 4 7.75397 1.25241 33.3001 -16.6469 -12.6897 -14.3012 +986 4 9.75614 1.90919 35.3591 7.11639 4.99627 7.91164 +987 2 10.1452 2.40125 33.2642 -9.36205 3.53781 1.41258 +988 2 11.145 1.26701 33.0621 15.3724 -18.5317 -10.2549 +989 2 12.3408 1.2215 34.0193 -34.6799 -20.8737 -4.25674 +990 3 13.4283 1.6066 33.6334 28.2263 9.73281 -4.88467 +991 1 12.1185 0.540183 35.1633 28.8031 2.35628 29.4382 +992 4 10.7148 3.34616 33.3936 1.59432 0.534457 -2.79864 +993 4 9.49714 2.55965 32.3759 6.01649 -0.268224 -5.10448 +994 4 11.6127 1.34439 32.0577 -0.769775 9.57011 -1.56393 +995 4 10.6933 0.251936 32.9886 -5.52334 3.35231 7.85959 +996 4 11.2139 0.219277 35.5156 -12.526 -0.0546681 -6.86711 +997 4 12.9016 0.455342 35.8573 -9.00019 3.15098 -17.6728 +998 1 9.24699 4.48326 35.2867 7.50516 -22.9453 -9.87373 +999 2 8.79457 5.81029 35.6553 19.4094 -0.44208 23.4194 +1000 2 7.94193 6.35186 34.5098 -28.0836 13.7832 22.6841 +1001 3 8.26577 6.15625 33.3485 3.32417 -1.59684 -17.5239 +1002 4 10.2626 4.25405 35.3107 -8.01304 16.2193 5.9612 +1003 4 8.1894 5.68577 36.5846 -11.6257 -0.00282829 -7.04897 +1004 2 9.97767 6.74716 36.1433 -23.7266 14.1696 -20.2452 +1005 2 11.1395 6.93836 35.1562 2.17384 -4.68321 -25.171 +1006 2 12.442 7.40754 35.8023 6.89417 23.6707 25.6501 +1007 2 12.3585 8.87197 36.3546 -17.7601 7.18701 6.16378 +1008 1 13.652 9.40345 36.7619 -5.05233 -10.0697 25.3038 +1009 4 10.4674 6.41708 37.0624 -6.17454 -12.8958 16.6295 +1010 4 9.46609 7.72624 36.4439 19.6997 -12.4825 -9.52898 +1011 4 10.8586 7.67723 34.3661 -2.31205 -2.27426 2.47252 +1012 4 11.3956 5.98923 34.5935 -8.15618 9.36142 7.97067 +1013 4 13.285 7.3766 35.0989 4.02069 -2.74272 -14.2107 +1014 4 12.7725 6.74228 36.6382 -4.94702 -0.810609 -4.3443 +1015 4 11.6162 8.97546 37.2517 21.5709 -5.37851 -23.6156 +1016 4 11.9848 9.59279 35.5592 1.32622 -13.234 7.43529 +1017 4 13.5097 10.3531 37.0548 1.1249 12.5728 4.15723 +1018 4 14.3076 9.4933 35.9914 2.38442 -5.54985 1.16984 +1019 4 14.0989 8.9471 37.5942 -8.28554 10.0467 -28.7492 +1020 1 6.74258 6.95961 34.8453 13.8439 -7.08515 -31.5666 +1021 2 5.70412 7.47847 33.9372 22.4359 17.1833 28.8896 +1022 2 4.73468 6.47268 33.3926 -37.2702 -51.3286 -21.7325 +1023 3 3.66084 6.82477 32.8505 20.0183 9.28716 8.38675 +1024 4 6.50761 7.12516 35.8163 -0.959582 1.3178 20.8718 +1025 4 5.07512 8.17388 34.5809 1.06569 -12.1955 -8.24357 +1026 2 6.27511 8.35576 32.8097 23.4106 2.51452 -13.5767 +1027 2 6.97942 9.67377 33.2004 -16.9954 14.0421 10.4255 +1028 2 6.10535 10.8129 33.826 12.866 -26.3315 -27.4761 +1029 3 5.32563 11.4369 33.048 -2.57309 4.89094 -0.177716 +1030 3 6.28787 11.1355 35.0235 5.56298 3.82152 16.5631 +1031 4 5.49496 8.55729 32.0786 -16.2509 9.70978 -5.42728 +1032 4 7.00993 7.79082 32.1666 -6.62982 -1.98309 13.432 +1033 4 7.44051 10.1227 32.2823 5.63402 -3.39012 2.91122 +1034 4 7.79617 9.4262 33.9151 4.88029 0.56984 -5.69246 +1035 1 4.9985 5.11713 33.407 24.659 21.8647 21.6253 +1036 2 4.05493 4.11234 32.9569 -19.5991 11.2557 -30.6753 +1037 2 2.66349 4.36425 33.564 5.77052 11.5327 33.941 +1038 3 2.61183 4.63212 34.7889 -10.6254 -2.1096 -24.9185 +1039 4 5.90798 4.72579 33.7623 -18.8375 16.0079 -6.75199 +1040 4 3.94963 4.2178 31.8123 4.18537 -9.18741 21.4869 +1041 2 4.52113 2.73738 33.4375 8.25229 -17.2331 29.0433 +1042 3 5.75234 2.38881 32.7881 -21.5054 -2.62865 -12.7372 +1043 4 3.76903 1.95227 33.2696 -3.85539 -5.9091 -13.5606 +1044 4 4.62925 2.69715 34.589 6.20333 6.93314 -25.3828 +1045 4 6.43526 2.61043 33.3995 7.46021 4.72267 11.925 +1046 1 1.55191 4.21884 32.8032 -14.0425 -5.15851 -21.6842 +1047 2 0.161375 4.25438 33.2368 -9.40026 13.4655 23.096 +1048 2 54.692 2.80115 33.3646 18.1492 -1.83923 -37.1888 +1049 3 54.7885 2.04564 32.3679 -9.76904 2.34815 11.9713 +1050 4 1.58614 3.87283 31.8209 11.2241 6.42129 12.946 +1051 4 0.0932821 4.78062 34.2407 6.57702 -9.00044 -6.29593 +1052 2 54.1421 5.03026 32.3092 -30.8516 -27.3257 32.8914 +1053 3 54.4529 6.38645 32.3432 43.6526 11.7784 12.1317 +1054 2 52.6693 5.00292 32.8811 18.0931 2.75777 -15.9968 +1055 4 54.1554 4.62002 31.3044 4.18983 -2.87474 -22.2473 +1056 4 53.8639 6.90955 31.8518 -25.2917 13.9269 -18.693 +1057 4 52.66 5.46781 33.8932 -7.48107 5.39969 -2.18241 +1058 4 52.249 3.98991 33.0062 0.231344 -5.48034 -3.27193 +1059 4 51.9963 5.5356 32.1423 1.66512 -1.40627 14.088 +1060 1 54.1705 2.41097 34.5199 1.80418 26.5965 31.5441 +1061 2 53.4771 1.1604 34.7223 -23.5881 -17.4143 30.2256 +1062 2 51.9672 1.43692 34.4286 45.4706 11.6959 19.6168 +1063 3 51.5098 2.51334 34.8139 -14.0548 -1.70012 -4.22959 +1064 4 54.1449 3.13072 35.3168 -2.84084 -28.6208 -21.3152 +1065 4 53.8073 0.317305 34.0552 7.54144 10.0832 -0.542806 +1066 2 53.6466 0.727247 36.2732 15.0023 -0.977243 -19.0787 +1067 2 0.11045 0.778115 36.8855 -3.47233 23.3808 -12.4462 +1068 2 0.174657 0.0352411 38.2454 9.71436 -6.65086 -1.81426 +1069 2 1.19132 0.222888 35.8995 6.11034 15.7938 3.95568 +1070 4 53.2393 41.6189 36.352 -4.11551 -11.0062 3.39296 +1071 4 53.0266 1.35722 36.9407 -10.5209 2.31976 -3.99924 +1072 4 0.276909 1.89779 37.0745 11.3679 -17.77 -1.06189 +1073 4 54.361 0.442618 38.9125 4.10216 -8.97134 2.26246 +1074 4 1.16474 0.174268 38.7716 -10.2453 4.64912 -5.91146 +1075 4 0.0894693 40.827 38.1128 -8.07449 10.5575 2.47406 +1076 4 2.18017 0.0911741 36.3628 0.498668 -8.86502 15.8712 +1077 4 1.51082 0.946112 35.1046 -21.6742 -5.82018 -4.77892 +1078 4 0.87048 41.1455 35.5035 3.84873 -0.316194 -7.96637 +1079 1 51.2572 0.510776 33.7869 -35.0849 -22.21 -18.422 +1080 2 49.7991 0.651464 33.5457 -7.89552 -1.42073 2.85742 +1081 2 49.1064 41.7127 34.6422 20.8091 24.7993 -30.4476 +1082 3 49.3211 40.5176 34.6928 0.936017 -16.9834 6.81615 +1083 4 51.5685 41.4333 33.6514 6.90564 11.6478 3.53197 +1084 4 49.4699 1.73569 33.6536 7.71362 -9.58165 1.5915 +1085 2 49.2914 0.124722 32.1435 -1.6477 0.542595 21.3952 +1086 2 49.5957 1.07684 31.016 -40.6033 -15.585 26.437 +1087 1 48.7294 1.99918 30.4836 -27.6566 13.4748 -4.54446 +1088 2 50.7297 1.21695 30.3262 36.7247 10.1326 -33.1818 +1089 2 49.2902 2.59089 29.4013 15.6758 12.8861 -16.3634 +1090 1 50.5605 2.13547 29.3267 -27.6128 -3.77706 23.4645 +1091 4 48.1729 41.8384 32.2733 14.3125 6.04861 -12.1255 +1092 4 49.7214 41.0254 31.9181 -0.443629 4.48635 2.11286 +1093 4 47.7408 2.2006 30.8029 20.1006 -6.4749 -2.25561 +1094 4 51.6449 0.698065 30.4056 15.084 -12.5894 5.57169 +1095 4 48.9104 3.2954 28.6425 -5.47018 -10.6135 19.6435 +1096 4 51.2563 2.40703 28.6421 12.9903 7.46191 -13.5301 +1097 1 48.3611 0.457254 35.523 -13.4783 35.8963 4.98689 +1098 2 47.6684 41.7265 36.6028 -12.609 2.82517 16.7739 +1099 2 46.2613 41.336 36.1362 14.2498 9.86212 -6.63619 +1100 3 45.3696 0.249228 35.9008 11.2544 -8.11188 8.40093 +1101 4 48.1527 1.47601 35.3837 2.04907 -15.0615 5.33592 +1102 4 48.2568 40.8085 36.8471 -2.89667 -2.02658 5.80089 +1103 2 47.5596 0.692305 37.8969 5.07609 12.8861 -15.4572 +1104 2 46.7247 0.067171 39.0652 -23.3887 -7.36646 -24.3057 +1105 2 47.033 40.4837 39.4166 -14.2982 16.8046 -18.6717 +1106 2 46.9311 0.907751 40.3269 20.2628 20.9695 31.7148 +1107 4 47.0803 1.72619 37.5586 18.4264 -28.4903 17.3716 +1108 4 48.6288 0.838001 38.2574 -15.841 5.68773 -4.62102 +1109 4 45.6307 0.107149 38.6982 15.4635 0.946246 17.2142 +1110 4 48.0197 40.3992 39.8616 17.8935 -6.94949 10.1905 +1111 4 47.0012 39.8155 38.524 1.84183 3.03864 3.36861 +1112 4 46.2605 40.0937 40.1174 3.5183 -0.242765 2.2201 +1113 4 48.0596 1.05972 40.5786 -27.9597 -7.64804 -5.61245 +1114 4 46.4366 0.492644 41.2461 4.13191 -4.52617 -8.48469 +1115 4 46.5029 1.93558 40.2678 1.33797 -2.98423 -8.86627 +1116 1 46.1363 40.0225 35.9719 -11.8784 -48.163 0.632693 +1117 2 44.9067 39.2611 35.7716 22.3959 0.0668878 -14.2888 +1118 2 44.4049 38.8629 37.1725 -35.2322 11.6067 -22.5418 +1119 3 45.1472 38.486 38.0617 14.0918 -2.68919 9.70234 +1120 4 46.908 39.3425 36.1226 1.34088 13.782 2.29065 +1121 4 44.2497 39.8817 35.1331 -17.245 4.97255 12.4072 +1122 2 45.2366 37.985 34.8925 -4.99104 -6.23114 -9.17669 +1123 2 44.0069 37.0072 34.8313 5.26574 11.342 7.98842 +1124 2 45.6195 38.3915 33.4226 -3.76358 -20.0352 6.70883 +1125 4 46.1177 37.4383 35.3134 -3.76426 -1.15462 7.05426 +1126 4 43.5316 36.9313 35.8696 0.358942 -6.34703 -24.4349 +1127 4 44.3242 35.9956 34.5249 4.20531 -7.16171 2.34616 +1128 4 43.2753 37.3126 34.0403 -3.87397 3.42825 10.5933 +1129 4 46.6384 38.8467 33.4221 -3.79452 2.69366 -2.61982 +1130 4 44.9004 39.1304 33.0043 0.823619 -0.608417 -3.73086 +1131 4 45.6564 37.4663 32.7381 0.0287792 19.4258 11.3413 +1132 1 43.0561 38.9062 37.36 16.7964 -0.846157 38.4014 +1133 2 42.4272 38.5172 38.6279 -14.5421 -18.7427 13.0828 +1134 2 41.8753 37.0763 38.5124 -8.78692 12.5845 -64.2445 +1135 3 41.466 36.6885 37.3717 6.29707 6.96761 32.6735 +1136 4 42.3774 39.0214 36.6331 -15.2734 7.16413 -28.2079 +1137 4 43.1919 38.4467 39.4108 16.1917 0.0561369 8.47296 +1138 2 41.3404 39.5151 39.1514 -18.2527 2.1619 5.40726 +1139 2 42.0205 40.8503 39.6333 -29.5812 13.2835 -20.5362 +1140 2 41.0689 0.171231 39.4112 30.2059 17.4331 -9.29433 +1141 2 42.4678 40.816 41.1078 15.9246 -23.8206 -10.1516 +1142 4 40.688 39.0893 39.9799 16.7303 0.907162 -6.07322 +1143 4 40.5588 39.6983 38.3606 15.4269 0.857054 0.728379 +1144 4 42.8535 41.0549 38.9416 17.5291 -0.3509 1.61726 +1145 4 41.6271 1.1561 39.6676 -14.9721 -22.7636 -0.520954 +1146 4 40.1564 0.111331 40.0029 -13.6089 -0.269988 10.9836 +1147 4 40.76 0.320829 38.3386 1.94315 -8.64923 8.74761 +1148 4 41.6626 40.4848 41.7802 -9.99726 5.60483 6.07701 +1149 4 42.8258 41.8281 41.4135 4.90552 -5.57863 6.49728 +1150 4 43.2679 40.0127 41.241 -4.54696 19.1865 -0.92221 +1151 1 41.8233 36.2733 39.5754 -3.61756 -11.0936 16.9633 +1152 2 41.1922 34.957 39.6399 -10.4088 -17.6704 -50.7121 +1153 2 39.8412 35.0841 40.3193 -0.437683 4.39576 10.763 +1154 3 39.8144 35.4746 41.4864 -9.76 5.96233 -2.547 +1155 4 42.2323 36.5766 40.4577 6.86651 4.46574 10.4638 +1156 4 40.9934 34.6386 38.4963 8.65196 -1.15376 42.0164 +1157 2 42.0562 33.8903 40.4247 20.8855 33.0106 -9.02378 +1158 2 41.3005 32.6543 41 38.0556 15.2529 -12.1112 +1159 2 42.2217 31.3951 41.1067 -29.8496 -30.3433 -13.4218 +1160 1 43.3285 31.549 0.111927 13.7517 39.8644 23.5527 +1161 2 44.3839 30.7268 0.286736 21.6234 19.2182 17.9174 +1162 1 44.681 29.6113 41.5428 -25.8767 -16.3024 -25.7307 +1163 1 45.3493 31.1499 1.13058 -39.3833 23.49 -6.35183 +1164 4 42.617 34.5166 41.192 -12.3652 -23.3828 3.531 +1165 4 42.8948 33.5841 39.7601 -4.64767 -6.80459 -5.17496 +1166 4 40.4819 32.4474 40.3056 -13.8786 -11.9041 -4.8646 +1167 4 40.8645 32.9834 0.0421702 -8.7777 -8.2778 13.4879 +1168 4 42.5872 31.067 40.0872 -0.36901 12.0823 9.30135 +1169 4 41.553 30.5032 41.4129 16.6518 20.7036 2.18161 +1170 4 43.3615 32.497 0.627799 -1.11121 -36.4642 -14.6418 +1171 4 44.0326 29.3067 40.7749 11.9664 -0.606259 12.9296 +1172 4 45.4908 28.9966 41.7635 -4.5997 7.04477 0.652143 +1173 4 45.2947 32.0222 1.6989 -3.32167 -9.1207 -8.17541 +1174 4 46.1369 30.5772 1.3332 29.28 -20.6173 7.21336 +1175 1 38.7318 34.7203 39.6307 -5.56998 -4.40152 -32.2775 +1176 2 37.3555 34.7738 40.1542 17.1032 1.0045 -6.37855 +1177 2 37.2353 33.667 41.1913 -33.3614 37.0741 40.0449 +1178 3 37.7005 32.5636 40.9891 18.731 -32.0974 -3.65368 +1179 4 38.8335 34.3404 38.6486 -6.51334 12.5121 23.5529 +1180 4 37.2672 35.7762 40.6273 -9.086 1.46109 5.84779 +1181 2 36.2453 34.5638 39.0845 -6.93832 -9.37108 -7.97374 +1182 2 36.1701 35.614 37.9414 8.91404 15.2365 -6.3275 +1183 2 35.3527 35.0344 36.7472 39.8054 8.21108 -27.9 +1184 2 35.4841 36.9314 38.4139 -18.287 13.7727 -16.8718 +1185 4 35.232 34.5024 39.5744 7.45292 -0.257102 0.0904576 +1186 4 36.3852 33.5433 38.6164 0.781265 7.17557 6.89015 +1187 4 37.2115 35.9047 37.5843 -11.2451 -10.8797 5.10717 +1188 4 35.5662 35.6385 35.778 -16.1675 -5.48794 25.897 +1189 4 34.291 34.967 37.0013 -15.7304 -0.876038 -4.35202 +1190 4 35.7074 34.0135 36.4456 -4.10332 3.28733 9.08934 +1191 4 35.4655 37.7439 37.5577 -4.97646 -27.0735 23.6494 +1192 4 36.0148 37.4196 39.237 12.1669 1.46201 8.99598 +1193 4 34.4369 36.7462 38.8365 16.8945 3.16641 -16.172 +1194 1 36.5334 33.9935 0.435925 10.1465 7.38421 -15.9691 +1195 2 36.4058 33.2568 1.6875 16.4821 -29.3274 -13.0782 +1196 2 35.1468 33.6833 2.42741 -3.52585 26.4938 2.22063 +1197 3 34.7699 34.8785 2.50349 9.50092 -20.8144 -9.83338 +1198 4 35.9506 34.8486 0.439937 7.33038 -6.12466 -5.51472 +1199 4 36.3499 32.1247 1.42412 1.62075 26.2077 7.36918 +1200 2 37.675 33.5505 2.58336 -0.681506 -6.35683 7.58589 +1201 2 37.7854 32.6927 3.8625 18.6921 -17.668 32.0141 +1202 2 39.0575 32.9332 4.76873 14.2724 -20.5826 -30.9069 +1203 1 39.1289 34.2491 5.33109 11.0713 19.2422 13.5273 +1204 2 40.0441 34.6938 6.2528 -38.5124 5.77538 -21.346 +1205 1 41.0523 34.0015 6.75388 -9.3068 -30.315 -40.8639 +1206 1 39.7573 35.8959 6.75045 4.65044 -37.6482 -19.533 +1207 4 37.7117 34.6025 2.94212 -4.78803 6.98284 -11.1897 +1208 4 38.6033 33.3783 1.98429 -1.50456 2.19712 -0.683264 +1209 4 37.8193 31.5994 3.65006 -4.42508 0.799529 -11.9295 +1210 4 36.9318 32.7949 4.56147 -11.5542 5.52665 -5.70323 +1211 4 39.9727 32.6563 4.13477 -10.3426 12.9457 13.0222 +1212 4 39.0991 32.232 5.62646 -6.41615 -9.9444 -1.6393 +1213 4 38.3112 34.8566 5.12728 9.08197 -0.1797 3.06874 +1214 4 41.338 33.0965 6.26824 1.29043 26.2885 21.8424 +1215 4 41.5567 34.3995 7.53172 18.6054 -2.34736 15.9895 +1216 4 38.9283 36.4191 6.51463 -17.6749 8.57537 -7.4588 +1217 4 40.3535 36.2619 7.44459 24.2502 25.7988 36.1589 +1218 1 34.4423 32.7029 2.99518 -5.91218 -18.2551 8.17758 +1219 2 33.2643 32.9205 3.78866 2.14491 3.18155 15.0212 +1220 2 32.3114 31.74 3.93685 27.6029 1.93064 -50.2862 +1221 3 31.6521 31.6162 4.95167 -20.1995 -6.42992 23.3772 +1222 4 34.7506 31.7123 2.9878 2.11082 4.57648 -1.08475 +1223 4 33.5885 33.2179 4.82725 -4.56531 -3.45872 -11.3922 +1224 4 32.6993 33.791 3.40271 -6.19117 1.50996 -1.33542 +1225 1 32.2733 30.8792 2.86255 -3.44833 -0.807911 26.2314 +1226 2 31.5067 29.6456 2.87911 -22.6819 -12.0155 6.38652 +1227 2 32.0275 28.5204 1.99364 -17.4826 -15.7648 -26.1521 +1228 3 31.24 27.9052 1.1757 18.2868 13.9435 17.0259 +1229 4 32.9257 31.0189 2.07167 -6.99587 -10.4877 -2.31778 +1230 4 31.4409 29.1882 3.92659 1.7726 14.0477 -11.6562 +1231 4 30.4172 29.8482 2.57519 20.7941 0.876843 7.98191 +1232 3 33.2432 28.1769 2.02662 6.75216 10.2675 5.6015 +1233 6 29.6689 33.0345 2.6027 6.39732 3.7635 -6.59735 +1234 4 28.7656 33.0857 2.95028 -0.371973 -14.4593 -6.85361 +1235 4 29.8153 32.1814 2.14015 -8.59972 11.6466 4.8732 +1236 6 1.91326 24.7635 28.0772 5.65317 -6.35183 16.4854 +1237 4 1.01929 24.4316 28.2568 3.94453 1.46201 -0.938269 +1238 4 2.46517 24.4471 28.8255 -6.59296 2.11781 -11.8027 +1239 6 8.98979 35.4216 7.06427 2.13264 0.908259 -3.07356 +1240 4 8.22375 36.0041 6.95701 -0.608539 -3.26387 0.365744 +1241 4 9.74616 35.991 6.87666 4.70766 2.91314 -0.442423 +1242 6 37.9357 35.2342 23.5273 -23.102 9.18642 19.8247 +1243 4 37.5041 35.2968 22.6705 0.513901 -3.82007 -8.89977 +1244 4 38.8432 35.0218 23.4038 20.8563 -8.17935 -11.4372 +1245 6 11.3793 34.6137 20.3253 14.1507 4.32837 -4.20952 +1246 4 10.4755 34.624 20.6003 -22.0831 6.77293 1.73618 +1247 4 11.7264 33.9016 20.8561 13.9299 -11.0914 4.04985 +1248 6 3.06607 13.1144 13.5167 22.577 18.8722 18.6067 +1249 4 2.20388 12.8262 13.8046 -7.02328 -4.57126 0.810516 +1250 4 3.32154 13.8092 14.1761 -2.44089 -14.0351 -15.8923 +1251 6 9.17443 22.3777 24.8954 -7.42914 3.56866 8.74917 +1252 4 9.07626 22.0242 24.0039 2.26474 -2.4656 -3.7019 +1253 4 8.26912 22.4958 25.2295 3.15193 -1.43545 -3.27774 +1254 6 31.1464 36.1236 7.45234 10.6607 -18.1227 -24.2194 +1255 4 30.9334 35.2222 7.12747 -5.34615 12.6105 12.538 +1256 4 31.8314 36.3443 6.79825 -5.43643 8.62165 8.26122 +1257 6 20.3227 0.172698 30.1419 10.3105 -3.05703 7.76208 +1258 4 20.0388 1.0684 29.8874 5.3247 -3.32009 0.781739 +1259 4 21.2583 0.228399 30.4322 -11.2768 6.47679 -5.28094 +1260 6 32.6859 3.01778 5.15829 -10.6028 -19.0303 43.6625 +1261 4 32.0356 2.3058 5.02019 7.54008 9.83835 -8.28794 +1262 4 32.7128 3.00557 6.15578 5.12118 6.62375 -23.7252 +1263 6 26.2374 8.27856 11.5971 17.869 0.788073 20.0593 +1264 4 26.2346 7.39991 12.0216 -0.142457 7.42091 -4.28305 +1265 4 26.8978 8.79254 12.1302 -17.5189 -15.6641 -18.5798 +1266 6 1.09614 20.2561 0.875192 -22.9747 0.467748 19.1373 +1267 4 0.851949 19.3199 1.10255 19.4844 20.3298 -11.3195 +1268 4 1.85437 20.3448 0.297385 12.1513 -16.76 -9.59627 +1269 6 29.1514 22.9126 1.42851 -3.57267 15.5796 12.2113 +1270 4 28.6966 23.7416 1.67141 5.52941 -12.1705 -9.88265 +1271 4 29.6634 22.7027 2.22543 0.165437 -2.26551 -2.85175 +1272 6 34.1399 34.826 6.47271 -4.00425 12.5535 -7.93856 +1273 4 34.8635 34.3401 6.10458 13.259 -3.54932 -9.87122 +1274 4 33.9387 34.3337 7.25184 -8.28913 -2.66912 16.7304 +1275 6 25.1643 37.1931 26.5228 17.2229 -22.0393 -23.1844 +1276 4 24.6935 37.7676 27.1042 -4.31343 22.2846 18.4719 +1277 4 26.0117 37.6203 26.271 -7.79876 5.52479 6.28113 +1278 6 14.5333 22.2337 15.6719 -21.8235 -40.5779 4.16881 +1279 4 14.0435 21.3187 15.7268 23.5152 50.9834 -4.51283 +1280 4 14.2451 22.7392 14.8947 -1.224 -10.8945 3.63574 +1281 6 2.86145 5.86342 4.09514 -12.0928 12.5672 -7.55007 +1282 4 3.31871 5.53612 4.87755 -0.114002 3.3263 11.1441 +1283 4 2.36891 6.69134 4.30817 11.5092 -15.7361 4.93451 +1284 6 27.6072 26.7133 22.7037 11.3111 -21.4893 35.9413 +1285 4 26.8221 26.1673 22.7712 -7.10606 -4.70529 -2.97044 +1286 4 27.5145 27.2572 21.9514 -10.0855 20.8317 -32.7258 +1287 6 17.7799 0.609907 22.4001 -5.17757 10.6635 4.04288 +1288 4 17.0763 0.657064 23.0885 11.5181 4.04392 -9.91171 +1289 4 18.0806 1.5364 22.261 -7.85301 -10.5281 2.59652 +1290 6 8.08893 9.42761 10.5595 3.55537 5.25916 40.324 +1291 4 7.89361 10.322 10.3179 -9.19974 15.7377 -19.3495 +1292 4 8.16563 9.56196 11.5399 2.2102 -21.2534 -20.7584 +1293 6 15.3508 8.71886 30.755 5.09068 -14.416 21.7005 +1294 4 15.721 8.98141 29.9127 -5.17651 10.4904 -11.2194 +1295 4 14.5411 9.19598 30.997 6.64715 3.62724 -9.30987 +1296 6 11.0273 17.2714 37.5546 -8.62993 4.63856 -3.16721 +1297 4 10.646 18.1523 37.5049 13.3861 11.3255 -4.88271 +1298 4 10.2437 16.8378 37.8681 -2.55755 -24.0409 7.53141 +1299 6 42.0954 25.1585 20.3881 14.6842 1.84925 -24.6227 +1300 4 41.6997 25.8318 19.7943 -2.16553 -3.48259 16.6789 +1301 4 41.6994 25.1952 21.2528 -9.02961 7.39914 10.888 +1302 6 25.8656 4.70522 33.8434 4.94337 -17.9304 30.0995 +1303 4 25.7948 4.41246 32.9437 -1.56424 4.53154 -20.9619 +1304 4 25.7821 5.65919 33.9019 -2.93726 10.638 -9.31877 +1305 6 28.7565 10.7943 24.343 5.31048 -5.66707 -17.5237 +1306 4 29.0395 10.691 25.2776 6.61806 -8.7001 -20.887 +1307 4 29.3174 10.2678 23.7025 -8.86987 6.64124 26.5787 +1308 6 5.00601 41.813 11.1 6.11697 -35.3303 28.6791 +1309 4 5.97939 41.6679 11.0741 -12.7816 8.03831 -2.02432 +1310 4 4.68345 41.1078 11.7429 5.5471 25.1349 -25.8779 +1311 6 51.7607 12.785 30.1531 41.9873 7.8243 6.58168 +1312 4 51.5044 13.1989 29.3224 -3.76645 3.26875 -7.63234 +1313 4 52.7548 12.9452 30.2104 -29.821 -7.22149 1.35463 +1314 6 7.60527 6.19156 6.53697 16.5093 0.883216 -0.386471 +1315 4 6.7728 6.50088 6.91441 -4.77803 -9.70632 -1.71599 +1316 4 7.48617 5.31021 6.15237 -11.2115 3.19853 1.4886 +1317 6 14.6639 26.9856 30.1439 5.75321 15.8705 11.2484 +1318 4 14.5566 27.0259 31.1175 -3.12227 -7.05885 -13.9758 +1319 4 15.1715 27.7926 29.9326 -6.11328 -7.83436 0.701957 +1320 6 15.3386 3.73742 21.1629 -49.5233 -4.42818 1.41573 +1321 4 14.7513 4.15862 21.8308 22.5595 -2.74077 -5.2282 +1322 4 14.679 3.20837 20.6508 28.7222 9.19721 3.95726 +1323 6 18.6168 30.4391 6.46727 22.6827 -23.6706 30.2016 +1324 4 19.0357 29.7477 7.08277 -19.2097 26.0479 -21.7287 +1325 4 19.3376 31.0911 6.37388 -10.7119 -2.89972 -1.77141 +1326 6 40.7683 1.30949 12.8061 -7.58564 4.37034 -9.51004 +1327 4 39.8743 1.70123 12.8539 8.02325 -2.8267 0.614513 +1328 4 41.1302 1.62292 11.9594 1.79027 -4.37486 1.66609 +1329 6 17.747 20.7401 41.5828 -14.5708 23.9699 -22.25 +1330 4 16.8287 21.1121 41.5273 18.852 -12.8662 8.2158 +1331 4 18.269 21.3043 40.983 -0.296974 -7.34806 11.4382 +1332 6 20.4522 2.1467 12.3338 -13.8993 16.4183 -18.7538 +1333 4 19.8428 1.38545 12.4588 7.32118 14.6694 -7.56396 +1334 4 20.1591 2.61844 11.4836 4.96023 -26.6086 29.2353 +1335 6 9.8437 37.1731 18.0697 32.5344 -3.69518 -7.02483 +1336 4 9.9915 37.607 18.9153 -11.6933 2.16478 7.61773 +1337 4 10.7629 37.1686 17.7045 -22.2666 -4.61022 -1.39483 +1338 6 22.8273 7.39987 18.8956 -5.5011 7.28813 -36.492 +1339 4 23.2632 7.84344 18.1165 -7.98371 -8.25387 20.5209 +1340 4 21.8866 7.2843 18.6392 14.3432 0.686453 4.84686 +1341 6 12.8601 6.85899 39.0577 6.92589 -13.3495 -12.6124 +1342 4 12.2887 7.60854 39.1608 -14.8411 14.7282 0.271429 +1343 4 13.3423 6.79713 39.8797 5.00888 -0.905409 12.2129 +1344 6 10.1643 2.40912 23.2548 -13.4149 21.1074 -1.06732 +1345 4 10.2774 2.03439 22.3894 8.18098 -13.9841 -15.6202 +1346 4 9.49692 3.09648 23.049 6.99386 -4.39158 13.7206 +1347 6 12.5495 20.2147 19.5723 7.26787 8.21028 -18.3895 +1348 4 11.6895 19.7983 19.735 -1.5185 0.18686 -8.43892 +1349 4 12.6119 20.404 18.6017 -2.05058 -6.51038 26.2392 +1350 6 53.8702 6.35891 18.9198 29.7306 -6.18586 8.10346 +1351 4 53.0457 6.06715 19.2818 -21.258 -2.7468 0.110915 +1352 4 54.4788 6.08079 19.6257 -1.29631 10.1734 -11.3531 +1353 6 1.76233 4.00968 13.2412 15.2049 -20.178 -6.82767 +1354 4 1.1126 4.5015 13.7221 -14.7745 7.27862 5.55391 +1355 4 1.46634 3.0803 13.3195 6.22895 8.64986 -3.00031 +1356 6 2.68809 16.4658 4.58471 15.0105 -8.44828 17.4213 +1357 4 3.47968 16.3912 5.17607 -18.0483 5.65918 -16.5792 +1358 4 2.952 17.0668 3.88721 1.61121 4.43717 -9.18758 +1359 6 22.6412 7.38905 35.0491 -42.342 -19.7774 -51.2585 +1360 4 21.8701 7.10292 34.411 47.7649 22.3984 34.2121 +1361 4 22.4927 6.7758 35.7601 0.300803 -9.30322 17.5195 +1362 6 30.6449 27.8966 19.9 11.2186 24.5725 -17.4668 +1363 4 31.067 28.6028 19.3405 -15.311 -24.4133 12.7333 +1364 4 30.0502 27.364 19.3383 6.18265 4.0422 4.40167 +1365 6 18.3584 9.54031 6.21119 11.0026 -3.68808 23.2716 +1366 4 18.3645 9.12256 5.3612 -2.33489 -5.22153 -19.3682 +1367 4 19.1216 9.13552 6.66909 -8.40358 6.03455 -2.63927 +1368 6 21.0207 30.3946 30.8361 -20.2261 -14.3153 8.76877 +1369 4 21.7305 31.0371 30.8947 0.539155 4.23503 10.2216 +1370 4 20.6128 30.1908 31.727 18.9681 11.2591 -24.4987 +1371 6 28.3223 4.36971 15.0862 0.785553 22.566 1.53388 +1372 4 27.9162 3.53142 15.2341 -13.4814 -22.4749 6.99245 +1373 4 29.0547 4.16931 14.5133 14.7433 -0.183871 -4.75122 +1374 6 12.7699 0.652736 16.5284 -10.9622 36.0111 -3.70833 +1375 4 13.1417 1.43405 17.0195 -7.22472 -23.339 -11.6266 +1376 4 12.1312 1.03058 15.8629 17.1298 -5.78525 17.4901 +1377 6 27.5613 35.204 8.24204 -17.5468 -3.17574 2.50179 +1378 4 28.0037 35.3359 7.41158 3.58667 2.22765 -10.9792 +1379 4 26.8513 34.5538 8.04841 12.0719 12.2779 8.55847 +1380 6 24.0727 5.16129 41.0114 25.3265 34.0312 4.62534 +1381 4 24.5764 6.00631 41.0278 8.83913 -22.6202 16.662 +1382 4 23.4512 5.41721 40.3589 -27.9927 -11.5371 -21.4854 +1383 6 16.8577 24.9409 28.3044 -13.362 20.9446 -8.34262 +1384 4 15.8529 24.9248 28.4711 42.0709 9.51562 -15.4474 +1385 4 17.0929 25.6637 27.6385 -20.1406 -20.6283 22.1367 +1386 6 20.8367 12.7872 17.016 48.1357 -13.7972 -0.957512 +1387 4 20.9831 13.7012 17.3244 -4.24853 -6.44611 -2.53838 +1388 4 21.7731 12.3998 16.8344 -46.2893 13.5674 8.59046 +1389 6 35.7698 23.0286 30.9167 1.31549 -8.15919 10.0357 +1390 4 34.8007 23.0783 30.9694 4.38358 -0.634017 0.107585 +1391 4 36.0504 22.6611 31.7855 -2.79806 7.45108 -14.1947 +1392 6 36.3049 21.4 25.8723 16.8231 15.2703 -10.059 +1393 4 35.3849 21.2313 25.7163 -23.5769 -6.11261 -4.10927 +1394 4 36.6855 20.6326 26.2849 5.24534 -13.4215 6.45433 +1395 6 13.4896 6.74946 5.28081 -28.3592 57.2786 25.4238 +1396 4 13.8414 6.02988 4.86679 44.4058 -71.9847 -33.7479 +1397 4 12.7199 6.9047 4.75258 -19.8414 9.95147 -1.72496 +1398 6 20.8046 20.4221 13.7595 5.24729 11.8597 -23.4966 +1399 4 21.3314 20.3763 14.5586 1.04488 -1.4591 8.76088 +1400 4 19.8874 20.2651 13.9627 -8.54986 -4.70556 7.47732 +1401 6 20.3763 29.1306 1.39291 -22.654 9.61717 24.1604 +1402 4 20.4714 29.8874 2.01179 2.99602 -8.49852 -9.62387 +1403 4 19.4639 28.7985 1.61052 22.0838 3.18086 -13.1329 +1404 6 50.878 13.1268 37.2744 -6.92527 18.9089 19.2141 +1405 4 51.431 12.5903 37.8743 -5.40112 9.96959 -2.47836 +1406 4 50.5327 13.8902 37.8162 10.8793 -23.2499 -13.6212 +1407 6 33.933 34.1706 20.4988 -24.935 23.2996 -4.02345 +1408 4 33.9537 34.3969 19.5503 3.97405 -5.2202 10.173 +1409 4 33.1424 34.6907 20.8306 20.6842 -17.0796 -4.50693 +1410 6 26.2139 28.0427 27.5441 -18.3219 -6.87449 2.92541 +1411 4 26.6233 28.4264 28.3298 2.52406 0.509022 -5.28732 +1412 4 25.2474 28.0355 27.7473 15.6982 -2.70826 -9.65401 +1413 6 7.68199 21.3044 4.2899 -23.4352 7.97399 30.3744 +1414 4 8.39223 20.9571 3.80392 40.3202 -21.1106 -20.5498 +1415 4 7.23721 21.8696 3.67656 -12.7303 12.1883 -10.427 +1416 6 21.997 15.1678 5.91921 0.156106 10.1967 -8.47357 +1417 4 22.4631 15.3078 5.09012 1.49736 10.8302 -2.43488 +1418 4 21.9323 14.2285 5.99467 -4.63281 -19.7734 10.7123 +1419 6 21.7161 24.0028 3.81129 14.7157 -6.77156 -2.79544 +1420 4 22.6514 24.278 3.99089 -16.266 -7.57571 -5.80044 +1421 4 21.7278 23.1773 3.27349 4.3704 10.7286 8.25651 +1422 6 11.5654 23.7677 12.5675 4.34126 23.9889 5.0328 +1423 4 11.8179 24.711 12.3772 -5.51197 -27.812 -0.203907 +1424 4 11.194 23.7871 13.4529 -2.51135 -1.17837 2.27349 +1425 6 32.365 18.0609 29.8133 5.42876 1.07285 10.0727 +1426 4 33.2855 17.8495 29.9872 2.18588 2.92383 8.75228 +1427 4 32.2516 17.686 28.9464 -9.45666 -7.03173 -17.6671 +1428 6 9.26057 12.3901 30.3108 6.69251 -5.93803 -6.45383 +1429 4 8.9331 13.0089 30.9751 -1.99931 -0.452864 0.983921 +1430 4 10.127 12.0766 30.6488 -15.6011 7.03664 -5.16285 +1431 6 40.1575 25.9297 9.14135 -21.3024 -7.39617 3.31146 +1432 4 40.7828 25.2448 9.36979 6.64832 -8.60816 0.262948 +1433 4 40.6901 26.6937 8.96671 10.3695 18.4246 -3.8085 +1434 6 43.1786 32.337 37.3292 -33.551 -18.2832 -9.28851 +1435 4 42.7165 32.8749 36.6701 14.8891 8.67062 4.46068 +1436 4 42.4294 31.7351 37.5575 24.0939 3.67107 5.33039 +1437 6 44.0961 6.28371 31.2632 9.51948 -8.69332 -33.5784 +1438 4 43.4914 6.92213 31.6058 -15.4833 19.2503 12.9198 +1439 4 44.559 5.89005 31.9835 8.76633 -8.79917 23.1113 +1440 6 10.2083 18.8859 19.6919 15.5822 -2.80816 -8.35433 +1441 4 10.2079 18.3466 20.4907 -1.18434 0.124911 0.125127 +1442 4 9.35433 19.315 19.665 -12.7717 3.54701 3.24565 +1443 6 7.05259 15.5816 15.0277 -11.6868 16.7681 -20.4125 +1444 4 7.21112 15.523 14.0697 -0.749561 -1.2692 3.08306 +1445 4 7.39122 14.7797 15.3874 7.84577 -24.8334 9.86289 +1446 6 24.5366 3.48359 27.8583 16.7503 5.69766 5.18976 +1447 4 23.7024 3.43271 28.3539 -4.73503 -2.50774 -10.2909 +1448 4 24.4259 3.10654 26.9763 -12.6917 -5.22111 2.5626 +1449 6 54.3931 31.8073 9.72289 -3.19054 17.1237 19.0803 +1450 4 53.9641 31.62 8.89214 -6.37727 -2.00813 -13.4715 +1451 4 54.1243 32.7301 9.92854 3.65429 -15.124 -2.64791 +1452 6 6.79493 17.0949 36.2025 -8.81624 7.47492 14.5397 +1453 4 5.9165 16.6466 36.2092 18.1356 5.91394 -12.2869 +1454 4 7.21103 17.1598 35.3293 -13.3551 -7.88765 -1.67162 +1455 6 28.633 7.46221 20.4165 -21.0133 14.9556 -29.8407 +1456 4 27.7506 7.6389 20.7846 4.83271 -6.12746 3.71795 +1457 4 28.5316 7.77661 19.4783 9.56717 -7.40103 22.9991 +1458 6 17.0376 1.7027 8.35788 5.34968 28.5352 32.0038 +1459 4 17.0661 0.753124 8.28199 -2.4228 -14.8367 -20.8379 +1460 4 16.762 2.22772 7.59129 -1.56258 -15.3605 -8.12812 +1461 6 19.1384 19.3343 35.5751 19.5023 3.30605 7.15282 +1462 4 18.4451 18.7061 35.4179 -10.2251 -8.92118 -4.92207 +1463 4 19.8852 18.808 35.914 -3.54436 4.66685 -0.605832 +1464 6 7.31639 31.3666 13.5695 -43.9944 -20.214 -21.2721 +1465 4 6.78612 30.574 13.8569 21.4883 17.7075 -0.698983 +1466 4 6.68503 31.7843 12.9295 22.0056 -0.349161 9.64417 +1467 6 16.674 5.24419 12.8556 -11.0373 -33.5815 5.02698 +1468 4 17.465 5.75961 12.9546 20.2971 3.5869 6.63236 +1469 4 16.7677 4.34295 13.2785 1.53127 21.9447 -10.2143 +1470 6 43.8803 12.7494 34.5747 -22.4085 -20.9808 -0.0671255 +1471 4 43.9515 13.6536 34.2548 -4.30422 8.76569 -3.51904 +1472 4 42.9542 12.429 34.42 18.6754 8.57765 -0.433924 +1473 6 42.6607 36.4569 28.5239 -16.8168 -12.4187 2.20896 +1474 4 42.172 37.2929 28.6321 13.9601 -3.78206 -4.91178 +1475 4 43.5913 36.5775 28.2923 4.62592 13.2896 -0.105187 +1476 6 35.3772 15.0586 6.04009 27.912 48.9275 -7.18458 +1477 4 35.887 15.8982 5.7897 -19.1126 -32.2788 12.1212 +1478 4 34.8045 14.9281 5.27735 -5.52923 -7.04807 -1.55591 +1479 6 19.4078 5.85855 6.1829 -40.2001 -18.9085 -3.31614 +1480 4 18.5441 5.99364 6.63156 8.43156 -9.10613 -8.3884 +1481 4 19.928 6.53616 6.54489 31.8426 31.4232 15.0663 +1482 6 29.261 38.1682 6.98131 -37.2303 32.1811 -6.57247 +1483 4 28.4837 38.0966 7.57517 15.5489 -1.40449 -6.41795 +1484 4 29.8842 37.5088 7.21603 19.671 -25.1607 10.5683 +1485 6 19.357 26.1782 8.47801 4.74765 -18.9961 17.9486 +1486 4 19.3733 25.7814 9.38274 -2.97831 10.6699 -17.265 +1487 4 20.1618 25.7953 8.09114 -4.76457 3.34604 0.730176 +1488 6 4.92328 16.6713 6.1398 7.47336 5.27851 2.26954 +1489 4 5.50113 17.3858 5.8203 -2.76896 -2.40075 1.51866 +1490 4 5.42288 15.8417 6.02573 -4.96937 12.5626 -0.560722 +1491 6 6.06184 16.6875 28.0703 25.9558 6.64688 1.10321 +1492 4 5.15824 16.4097 27.9597 -16.212 -5.66481 -14.185 +1493 4 6.48748 16.8231 27.1848 -21.9791 -6.00697 19.2504 +1494 6 21.7362 29.3702 22.1089 -17.2737 20.913 34.8846 +1495 4 21.4452 30.3289 22.1112 6.19611 -27.0689 0.469942 +1496 4 21.3293 28.9728 22.9428 14.5469 12.9694 -26.9427 +1497 6 24.4985 0.540505 12.8515 12.2489 -9.36427 2.95715 +1498 4 24.0437 0.939092 12.114 -3.50986 5.42614 -10.4761 +1499 4 24.1106 0.99496 13.5957 -0.561841 3.41965 12.163 +1500 6 18.4019 28.2584 40.3145 -11.401 19.5033 -15.6681 +1501 4 18.3886 27.6361 41.0165 -1.05122 -20.6036 22.2694 +1502 4 19.1831 28.024 39.826 8.23901 2.08545 -8.43276 +1503 6 10.3826 17.4565 21.9113 1.92941 -13.2413 3.45357 +1504 4 9.8824 16.6205 21.8349 3.82121 7.52813 2.02092 +1505 4 9.93899 17.9725 22.5913 -5.82795 2.16988 4.16556 +1506 6 13.5489 13.3588 39.6353 11.9209 29.8927 39.0415 +1507 4 13.8427 14.2544 39.3649 -8.64321 -16.3346 -3.85104 +1508 4 13.5548 13.4385 40.6332 -1.97454 -11.1079 -31.9482 +1509 6 19.5449 26.0093 24.7389 -52.2633 13.2593 -7.73686 +1510 4 19.57 25.3975 24.0097 10.2262 -10.7296 -10.4349 +1511 4 20.3304 26.0184 25.2393 35.6126 -10.3894 17.1361 +1512 6 8.93096 25.8929 20.0882 -7.71251 -64.4566 3.30388 +1513 4 8.30787 26.3938 20.5887 -11.4685 32.8171 11.63 +1514 4 9.62246 26.3511 19.648 20.7791 34.2926 -13.3665 +1515 6 13.4555 41.2072 30.5108 -10.8988 -15.928 5.69795 +1516 4 14.2767 41.1294 31.0436 -12.4449 -5.39064 -3.38157 +1517 4 12.7718 40.5451 30.8276 25.6688 18.9533 -5.69319 +1518 6 21.165 21.6707 11.1126 6.53241 11.8742 3.94385 +1519 4 20.8889 20.8699 10.6872 -6.5221 -17.8932 -11.6656 +1520 4 21.171 21.4318 12.0451 -0.673303 -0.892159 6.0991 +1521 6 43.5659 10.3222 15.565 -2.18625 -17.2881 -4.53442 +1522 4 43.269 9.50121 15.139 10.696 3.36153 7.59808 +1523 4 42.8911 10.937 15.2983 -10.0921 17.3133 -0.93945 +1524 6 23.5255 5.06673 12.3063 -8.27451 55.1521 -7.02327 +1525 4 23.4703 4.15364 12.096 -5.93718 -33.8878 -14.7403 +1526 4 23.077 5.57318 11.5535 15.1023 -26.9196 22.8331 +1527 6 9.29314 15.4001 4.25145 -3.86255 -4.02248 -25.5662 +1528 4 8.9509 16.1187 4.78154 1.1615 8.22379 13.6068 +1529 4 9.97933 14.9549 4.74249 8.84801 0.0887981 11.7331 +1530 6 26.7067 10.8779 17.5788 3.55047 -19.7627 -22.9275 +1531 4 26.5537 10.995 18.4988 -3.13636 8.79354 30.8805 +1532 4 26.79 11.729 17.1566 -1.16375 6.51516 1.16674 +1533 6 26.0497 23.6027 33.6801 19.5894 25.2732 20.1931 +1534 4 25.4452 23.9936 33.0304 1.52608 5.68176 -1.06817 +1535 4 26.6384 24.3139 34.1277 -30.0139 -24.8801 -23.6693 +1536 6 7.5709 10.5028 28.9083 -0.962228 -19.583 -21.6711 +1537 4 6.74329 10.4799 29.4005 3.80738 8.46019 8.36633 +1538 4 8.19878 11.0832 29.3397 0.629116 8.24646 12.7121 +1539 6 16.498 16.9072 24.6485 7.82025 23.6222 16.3151 +1540 4 16.0345 17.7596 24.5588 5.31695 -3.73313 -0.390286 +1541 4 16.1792 16.4208 23.9083 -7.11448 -16.9587 -21.9433 +1542 6 12.549 12.7866 0.448591 8.35618 6.39845 34.9671 +1543 4 12.9768 12.9146 1.38779 -15.5602 -17.6496 -50.0052 +1544 4 12.7689 11.9205 0.0349689 0.659473 7.36742 13.3893 +1545 6 6.80731 2.45617 9.05869 -7.23501 -7.03372 -0.578084 +1546 4 7.10343 3.02287 9.78944 7.77528 -6.31722 -2.26682 +1547 4 7.3272 1.63733 8.99034 2.01029 5.74015 6.94656 +1548 6 28.8877 11.8706 12.0154 41.6386 34.6329 -2.99516 +1549 4 28.2108 12.4771 11.6895 -6.34049 1.49886 1.56166 +1550 4 29.7533 12.3393 11.8008 -29.7579 -18.4108 8.17464 +1551 6 44.6745 32.5962 29.7139 -34.2161 4.66467 6.73964 +1552 4 43.7628 32.9784 29.4642 35.9402 -16.1761 10.2258 +1553 4 44.5125 31.9002 30.3967 -1.3182 18.2082 -15.8911 +1554 6 28.5995 15.1068 32.2872 13.2766 -51.3111 -20.1848 +1555 4 29.0279 15.8582 31.8991 2.31019 19.0875 -3.40369 +1556 4 29.0943 14.3419 31.8537 -21.7517 23.8731 20.1718 +1557 6 1.14062 22.1898 33.6289 -39.3586 14.574 19.5436 +1558 4 0.65227 22.798 33.0535 3.91391 -2.7929 6.08546 +1559 4 1.82717 21.8879 33.088 34.4042 -16.5957 -27.8984 +1560 6 17.4513 16.8201 9.93098 -1.82085 -23.3459 26.2514 +1561 4 17.8906 17.1746 9.18159 7.86355 15.3521 -22.135 +1562 4 18.0267 16.0779 10.2085 -7.73246 7.19916 -1.96586 +1563 6 18.7435 29.8048 14.4095 21.7061 -3.72347 40.0221 +1564 4 19.5652 29.5706 14.9087 -19.4331 3.67999 -8.42588 +1565 4 18.9661 29.6909 13.4944 1.97037 -1.23698 -19.2163 +1566 6 39.4071 6.51101 13.0179 12.0574 6.81682 -11.0022 +1567 4 39.7785 7.30288 12.5709 -10.193 -11.7897 7.6563 +1568 4 39.9532 5.78104 12.6849 -4.03584 4.98089 5.48617 +1569 6 54.0977 38.2821 14.3159 8.76467 -13.509 23.2458 +1570 4 53.5116 38.6447 15.0061 0.0542658 1.01747 -18.4972 +1571 4 53.8554 38.6311 13.4594 -12.9742 11.219 -5.93773 +1572 6 7.52036 32.013 20.9427 34.362 14.2167 21.5407 +1573 4 7.05735 31.9924 20.1252 -18.8869 -6.37038 -21.2822 +1574 4 7.04171 31.4816 21.5607 -16.1882 -11.3569 11.099 +1575 6 26.965 15.5039 13.8257 -10.8147 -22.3452 14.7237 +1576 4 27.2177 14.7358 14.3683 8.65177 6.42067 -5.59001 +1577 4 26.0429 15.6169 14.0906 -6.80859 9.66341 -6.51148 +1578 6 18.3782 16.4473 32.1249 -4.95226 -1.86998 -9.87987 +1579 4 18.1426 16.6374 31.1969 4.73263 -0.719504 8.39792 +1580 4 19.0836 17.0573 32.3614 6.73072 6.57595 -2.73442 +1581 6 52.4873 31.678 23.2415 -44.1119 -6.58328 47.4356 +1582 4 52.4708 32.2686 24.0415 7.23299 -8.75358 -21.8316 +1583 4 53.1739 31.883 22.645 31.3465 14.6123 -23.9869 +1584 6 2.16824 9.71317 28.2162 5.46837 -18.1801 7.45826 +1585 4 2.48183 10.5213 27.7929 -7.61484 8.72751 3.65687 +1586 4 1.37959 9.87032 28.768 3.44281 10.2362 -4.06622 +1587 6 32.9194 0.0905733 22.5781 10.5432 -20.5017 -7.42813 +1588 4 33.2395 41.1185 22.3208 -17.3926 6.61176 1.08087 +1589 4 33.7441 0.505918 22.8191 5.29332 16.1982 3.6992 +1590 6 20.7309 41.5697 38.6372 28.3147 -14.9122 -44.687 +1591 4 20.0328 41.0591 39.0281 -13.7779 -1.58578 11.2509 +1592 4 21.0348 40.9602 37.8857 -7.98591 29.4899 32.1121 +1593 6 43.3035 24.332 12.1458 11.7575 -1.61212 -4.71191 +1594 4 43.2118 25.2792 12.3722 8.64503 -11.1136 -9.01316 +1595 4 44.1249 24.1975 11.6011 -17.6772 13.9566 14.4164 +1596 6 22.028 36.2965 11.8178 -12.5217 11.0116 -6.64335 +1597 4 21.6755 36.9888 11.229 7.35556 -7.61462 10.605 +1598 4 22.8593 36.0261 11.4203 4.02803 -2.23458 -0.408194 +1599 6 50.7458 20.5312 30.3336 -27.3371 19.0798 0.575242 +1600 4 50.2829 20.0188 31.024 4.3389 0.549123 -5.17754 +1601 4 50.1148 21.2814 30.1453 20.3707 -20.1638 4.65154 +1602 6 20.8352 3.85006 18.1924 -4.58005 6.82859 16.651 +1603 4 21.6331 4.17131 17.7775 4.55578 1.29171 -4.07778 +1604 4 20.7516 4.34878 19.0287 -0.852135 -6.30171 -7.97465 +1605 6 4.00732 20.6422 6.98905 -51.5603 -31.2986 19.6291 +1606 4 3.1116 20.4695 6.56725 35.2765 12.481 -1.34365 +1607 4 3.83148 20.2497 7.8921 17.5771 16.9916 -21.2359 +1608 6 11.9503 15.4361 41.4392 2.8915 -19.3712 8.63656 +1609 4 11.9967 14.4718 41.7234 3.98465 29.7679 -14.4511 +1610 4 12.4631 15.5787 40.6176 -3.08486 -9.43894 7.49139 +1611 6 3.00006 18.5443 38.9307 7.29951 -23.84 25.6029 +1612 4 3.57591 17.7463 38.8471 -9.50595 12.5214 2.28144 +1613 4 2.93408 18.9335 38.0756 -3.85177 13.2219 -26.1975 +1614 6 8.60604 38.8696 11.3027 41.4164 30.2615 0.48057 +1615 4 9.41419 39.0226 10.7506 -16.8144 -5.25469 8.62565 +1616 4 8.21901 38.0768 10.9944 -17.9318 -38.1368 -15.4555 +1617 6 12.9777 33.9736 38.4849 13.2116 9.7409 3.49313 +1618 4 12.6169 33.1824 38.0476 12.8065 1.18326 0.516457 +1619 4 13.9558 34.0654 38.367 -20.6967 -9.66923 -0.235313 +1620 6 4.68265 11.9882 6.05233 -5.36104 -17.6375 -21.4001 +1621 4 3.82121 11.6194 5.80881 -7.3972 4.97776 10.103 +1622 4 5.22981 11.6659 5.30604 -0.806592 6.4598 12.5779 +1623 6 10.8388 15.9226 25.2234 -25.8257 0.885817 -3.68505 +1624 4 11.7194 16.2357 25.361 23.5714 9.8582 3.12124 +1625 4 10.3656 16.637 24.773 5.49819 -5.38784 0.449897 +1626 6 20.7519 3.25216 6.54608 14.2232 16.6176 4.63006 +1627 4 20.286 2.47445 6.25961 -10.3965 -11.4853 -2.16446 +1628 4 20.1859 4.03183 6.47283 -6.25253 -2.40724 -3.99784 +1629 6 47.6296 39.155 31.2075 -6.94169 16.2372 -29.2685 +1630 4 46.6717 39.1522 30.9686 19.778 5.05469 4.61154 +1631 4 48.0746 39.7923 30.5789 -18.3255 -25.0069 20.1215 +1632 6 8.32942 27.7692 27.6861 -22.9675 10.5768 13.2964 +1633 4 7.92083 27.0814 28.2574 8.55111 11.2092 -8.24047 +1634 4 9.05389 27.3382 27.2479 10.5137 -11.4359 -5.41666 +1635 6 33.26 40.3166 33.4176 17.9089 -0.14465 -4.13778 +1636 4 32.5337 40.9457 33.2593 10.2249 -4.59604 -5.86803 +1637 4 34.0027 40.4737 32.781 -17.2015 3.54767 8.86095 +1638 6 24.5063 34.6298 27.2698 0.491312 8.45089 -9.78892 +1639 4 24.8706 35.531 27.0561 -9.74802 -22.5685 0.190878 +1640 4 24.1 34.2837 26.4337 10.8101 11.1551 19.1745 +1641 6 13.3248 36.7606 35.7302 31.7841 1.54421 8.12469 +1642 4 14.2215 36.6075 36.119 -13.0291 10.9369 -8.07597 +1643 4 12.8242 36.0333 36.0767 -19.6956 -11.898 1.78685 +1644 6 34.0654 20.1519 33.2169 18.328 45.6356 -7.38724 +1645 4 34.7846 20.5927 32.7056 -13.2567 -20.8909 7.62801 +1646 4 33.6055 20.9496 33.5712 -4.62613 -21.3045 2.82084 +1647 6 22.8301 33.56 31.6141 4.86266 11.3389 -12.2002 +1648 4 23.5774 34.1707 31.5466 -2.83601 4.36281 -5.03091 +1649 4 23.1188 32.9172 32.2538 0.234413 -13.6868 11.6365 +1650 6 23.7437 2.42751 19.8437 5.37542 22.288 12.015 +1651 4 24.549 1.92657 19.7151 11.8542 -9.34304 -3.08207 +1652 4 23.0522 1.96699 19.3939 -17.1839 -15.7883 -12.7178 +1653 6 10.5922 1.64055 20.5239 -11.6119 -4.18685 -4.47424 +1654 4 10.0475 0.976152 20.0603 6.63037 0.339841 6.84259 +1655 4 10.5 2.45781 20.009 1.22375 1.55874 1.33627 +1656 6 6.49834 24.8637 7.80908 13.1619 -16.462 -27.2261 +1657 4 7.39752 24.8711 7.42138 -7.39511 8.18905 12.026 +1658 4 6.07255 24.1767 7.26903 -7.5733 6.7583 6.8074 +1659 6 54.7892 32.5297 25.4757 -1.36407 18.5665 -18.8778 +1660 4 54.0312 33.1434 25.3693 10.0694 -13.7478 6.1371 +1661 4 0.333918 32.6202 24.6425 -12.8409 -6.42816 22.883 +1662 6 6.2467 20.1884 28.9797 -14.5872 3.94595 -2.55046 +1663 4 5.42154 20.1642 28.4577 8.07739 1.90281 8.6477 +1664 4 6.84484 19.6236 28.4838 10.3646 -4.74821 0.341067 +1665 6 50.0565 21.6117 11.3373 -2.04109 28.5423 -29.4123 +1666 4 50.95 21.7264 10.9878 2.40449 3.31798 -5.14809 +1667 4 50.1463 20.9073 11.9368 0.900865 -33.3483 27.1981 +1668 6 43.4794 33.5181 19.6392 10.2306 -3.22473 -8.26676 +1669 4 43.7308 33.5714 20.5426 20.9097 -0.172793 18.6354 +1670 4 42.5556 33.6283 19.7345 -31.1875 3.87355 -8.92325 +1671 6 30.8203 7.18413 41.0653 -47.5647 29.7584 13.5959 +1672 4 29.9879 7.63165 40.681 33.629 -21.8567 10.9994 +1673 4 30.7637 7.50249 0.10761 7.36747 -14.0232 -31.1296 +1674 6 12.1328 25.8622 11.0863 -33.3162 -17.1307 -4.35232 +1675 4 11.2035 26.0164 10.7385 31.652 5.74526 10.6132 +1676 4 12.7063 26.6022 10.9281 7.22016 21.1466 -6.88425 +1677 6 47.8272 5.81934 17.7377 34.4122 -10.5063 -19.6374 +1678 4 48.0885 5.28838 16.9377 -7.84164 17.03 17.5567 +1679 4 48.6906 6.1712 18.0872 -20.5621 -5.0871 -4.09565 +1680 6 35.1646 12.9005 16.5891 -8.94037 2.15609 -8.82704 +1681 4 35.428 13.0005 17.5199 -6.39768 8.78744 -5.13392 +1682 4 34.5308 13.6301 16.3523 17.2323 -15.7422 12.9621 +1683 6 10.4611 10.6156 33.9687 -31.8989 -9.58391 14.7288 +1684 4 10.7981 11.3375 34.5166 5.24051 -2.75865 -7.26377 +1685 4 9.62118 10.4004 34.4306 17.5569 -1.50819 -12.473 +1686 6 9.86916 7.4616 9.67483 -1.17411 0.415312 -19.5192 +1687 4 9.17172 8.12646 9.7346 0.921409 2.8109 10.1471 +1688 4 9.97058 7.3459 8.70248 1.1017 -0.154201 19.4763 +1689 6 11.1489 9.5612 29.1408 -3.50418 -13.4139 2.93109 +1690 4 10.6848 9.26325 29.9428 4.68224 5.10434 -5.79998 +1691 4 11.3989 8.73954 28.6776 0.998479 5.88331 1.3781 +1692 6 46.4028 12.7539 37.8993 8.34964 0.221 -8.93676 +1693 4 46.6625 12.9969 36.9769 -3.46511 -1.57209 17.4302 +1694 4 46.8246 13.3669 38.5286 -1.63466 -3.53539 -5.22058 +1695 6 4.76485 19.028 16.0085 -13.5875 12.8334 -9.71245 +1696 4 4.2246 19.0797 16.8211 14.4547 -7.44532 -2.23877 +1697 4 5.5965 18.5831 16.2078 1.83868 -2.3176 10.3072 +1698 6 50.2593 39.8135 19.3633 -11.209 7.32279 -16.1387 +1699 4 50.2357 39.0929 20.0186 -9.83071 -0.813057 -10.1916 +1700 4 49.5811 39.7404 18.6324 20.3589 -6.83946 23.6454 +1701 6 3.57863 23.2976 26.309 -19.8478 3.89203 -2.42552 +1702 4 2.95325 23.1663 25.5593 11.1236 -1.69658 12.5574 +1703 4 3.09228 23.9147 26.9028 8.7219 -10.8877 -9.85517 +1704 6 43.325 18.2347 20.509 -6.81505 -1.42332 -3.46621 +1705 4 42.8171 19.0284 20.7204 1.20306 1.51529 1.23812 +1706 4 43.8577 18.0426 21.2915 2.12676 -2.58083 4.4502 +1707 6 14.5031 41.5275 19.7277 -3.40329 -5.13047 -40.8094 +1708 4 13.9246 41.7804 20.437 0.184992 5.83632 25.1113 +1709 4 15.42 41.4218 19.9774 10.3149 -1.62678 14.571 +1710 6 29.2836 29.8681 26.9083 14.7251 3.00272 -32.0725 +1711 4 29.2754 29.741 25.8744 6.18055 14.2787 56.2455 +1712 4 30.1283 30.2623 27.2985 -22.384 -15.5718 -22.4063 +1713 6 6.3217 26.153 11.5726 -10.9318 2.11689 -6.65038 +1714 4 6.21736 25.7454 12.4421 7.16784 6.77942 9.71283 +1715 4 6.96084 26.8819 11.5675 -0.124344 -5.20772 8.78036 +1716 6 27.6636 9.22988 15.2432 27.2347 15.0341 -6.49447 +1717 4 28.4103 9.83484 14.9873 -20.1055 -14.3916 8.85848 +1718 4 27.7674 8.48088 14.6445 -1.45999 -3.40178 1.02673 +1719 6 29.7804 38.0662 17.0819 -1.94795 -3.59677 -9.66723 +1720 4 29.6031 37.2203 16.6025 -2.55573 18.1678 4.54076 +1721 4 29.1155 38.7497 16.8561 3.55432 -16.3657 1.57327 +1722 6 52.2257 28.7184 4.26028 43.5541 11.735 -13.9492 +1723 4 53.1498 28.7813 3.86382 -28.9168 1.3453 15.0129 +1724 4 51.9642 27.8111 4.13511 -4.98861 -18.1961 -3.0857 +1725 6 17.1716 16.6708 6.09349 0.800403 22.8617 11.3476 +1726 4 16.9906 17.4665 6.64994 5.32834 -8.85643 -15.9231 +1727 4 16.9912 15.9587 6.69883 -0.0606397 -19.1034 5.18453 +1728 6 36.6551 7.54529 33.4256 0.520164 -21.8515 26.6937 +1729 4 35.9994 7.02185 33.9501 8.71508 10.7979 -12.9224 +1730 4 36.139 7.85703 32.6949 -12.9525 8.58568 -17.7829 +1731 6 26.1712 3.13186 9.59195 18.1066 21.2961 -28.5304 +1732 4 26.5502 3.5196 10.357 16.0028 12.4994 23.003 +1733 4 25.6506 2.45477 9.93435 -32.3265 -38.1289 14.2303 +1734 6 1.19956 17.1196 33.1708 -2.2935 18.3305 -9.07621 +1735 4 1.01553 17.8006 32.4822 1.56489 -10.8534 12.1427 +1736 4 0.844206 17.4429 34.0214 2.04572 -1.59411 -6.06332 +1737 6 29.1739 10.178 5.37516 -2.40587 -18.3881 11.7134 +1738 4 28.5386 10.354 6.08377 0.376669 4.93981 -3.98875 +1739 4 29.4881 9.26834 5.54278 -5.29161 7.67482 -7.40705 +1740 6 9.22817 21.1342 0.188585 30.2393 3.90367 9.01386 +1741 4 10.0008 20.6689 41.6954 -19.6386 2.89796 1.05729 +1742 4 8.40981 20.8027 41.7407 -2.68979 -7.66638 -7.21336 +1743 6 7.42006 26.8879 34.8536 3.14545 16.5486 30.4349 +1744 4 7.04622 27.0927 35.7464 10.1233 -6.04195 -26.4158 +1745 4 6.87255 26.19 34.5186 -13.4343 -18.5802 -10.0193 +1746 6 18.6153 10.1647 3.02259 -21.2705 37.3854 6.86975 +1747 4 17.9982 9.42011 2.89287 2.11135 15.8633 3.52195 +1748 4 18.115 11.0437 3.25865 19.508 -44.5053 -11.6159 +1749 6 13.1266 21.2208 25.207 -7.78894 4.80204 -7.88194 +1750 4 12.927 21.6586 24.3646 3.95449 -7.72121 4.87382 +1751 4 12.8054 20.3208 25.1571 -2.69895 -8.80511 -3.48609 +1752 6 4.90585 24.4116 40.531 -24.4864 -14.2944 -35.1794 +1753 4 5.64285 24.6041 41.0938 21.6142 3.21823 7.1591 +1754 4 5.22115 23.997 39.6806 -3.1008 12.4445 27.1665 +1755 6 54.7234 6.29054 9.93868 16.9838 3.76988 -11.4262 +1756 4 54.1595 6.0167 10.6465 -16.0707 -8.53288 16.3243 +1757 4 -0.00708757 7.17696 10.1972 2.88265 8.42125 0.296955 +1758 6 51.7481 16.6603 19.3703 -0.380283 5.87397 -29.4424 +1759 4 51.6376 16.2748 18.4816 -6.94363 -1.60509 11.109 +1760 4 52.3909 17.3585 19.2003 6.35466 6.30558 5.78841 +1761 6 38.6244 2.9738 13.1093 11.8256 2.30897 44.7329 +1762 4 38.5518 3.44318 13.9917 -0.399232 -9.9856 -23.4333 +1763 4 38.2423 3.54447 12.4592 -11.1085 17.5319 -17.0773 +1764 6 19.4422 35.7095 9.59568 3.40577 -0.828385 -4.73593 +1765 4 18.7414 36.105 9.07989 -9.16576 -3.00828 -7.06541 +1766 4 19.0009 35.4265 10.4088 3.97598 4.46758 -4.25365 +1767 6 46.943 37.6271 25.6985 10.3793 1.77648 -5.56802 +1768 4 47.12 37.9785 24.823 -9.34628 8.6078 -10.4475 +1769 4 47.7536 37.1497 25.8683 2.27046 -5.59472 9.98269 +1770 6 20.0359 17.269 14.7493 3.99527 -1.04076 21.685 +1771 4 19.226 17.5112 15.2169 -1.54973 1.23777 -13.9596 +1772 4 20.6203 17.0021 15.471 1.89523 -0.789097 -10.2839 +1773 6 24.7462 29.2867 3.75843 -10.1451 -8.18783 10.4774 +1774 4 24.6712 28.3277 3.51733 13.2212 23.8029 -9.5704 +1775 4 25.3186 29.8222 3.19111 0.258423 -15.3949 -10.1904 +1776 6 3.43 8.91865 6.82525 30.9316 4.78471 42.1024 +1777 4 3.12906 8.84201 7.76799 3.51474 0.65101 -30.0512 +1778 4 4.4001 9.15772 6.93718 -35.8795 -6.21414 -10.2854 +1779 6 17.4867 30.5875 19.7089 25.363 -13.1809 -11.8275 +1780 4 18.4189 30.3609 19.3993 -33.7851 8.31766 10.936 +1781 4 16.9116 29.8624 19.4038 1.038 7.7974 -2.73085 +1782 6 13.2718 16.1862 39.0546 8.76191 -18.4723 6.03369 +1783 4 13.8233 16.8904 39.4031 3.30361 7.54485 1.72389 +1784 4 12.5422 16.5765 38.5789 -11.7633 13.4881 -8.40344 +1785 6 23.832 27.9756 11.5898 -7.03122 5.38421 -2.05105 +1786 4 23.0756 27.4469 11.9259 8.81977 12.3317 -3.01362 +1787 4 23.7182 28.9056 11.8688 -5.28793 -12.9553 -0.41204 +1788 6 14.4579 24.426 21.2343 -3.66896 12.863 -1.79834 +1789 4 13.9584 25.2806 21.2855 7.33453 -15.5065 2.73981 +1790 4 14.2661 23.9117 22.0367 -3.91682 9.90798 -0.991428 +1791 6 46.6073 15.1543 22.2965 -20.8333 -3.77381 -11.8272 +1792 4 45.9584 14.6421 21.811 -6.87655 -3.95362 10.1018 +1793 4 47.2458 15.2644 21.6001 24.1162 10.8017 0.759212 +1794 6 19.1409 29.7195 11.8497 24.0494 -34.2428 10.0272 +1795 4 18.8784 30.5975 11.5793 -19.1418 4.86007 -17.3781 +1796 4 18.6106 28.9994 11.4276 0.263541 23.8948 1.0376 +1797 6 36.9127 18.8084 27.6222 -22.9356 -21.6011 26.171 +1798 4 36.4352 18.471 26.8408 6.36827 4.7914 5.64024 +1799 4 36.536 18.2194 28.3533 14.6987 24.2872 -28.1415 +1800 6 35.8684 17.5378 25.4906 20.6945 -0.513689 -30.4481 +1801 4 36.5966 17.7728 24.866 -15.8574 8.27186 11.6809 +1802 4 35.9779 16.5759 25.48 -10.902 2.42848 10.2606 +1803 6 8.03691 41.9141 31.5248 13.0394 10.4535 -6.8036 +1804 4 8.57921 41.2412 31.9888 -13.1962 14.522 -11.1095 +1805 4 8.63283 0.684743 31.1326 -8.3799 -15.4286 7.32752 +1806 6 31.7059 34.8342 17.9371 1.99631 -25.0047 -8.79133 +1807 4 32.5911 34.4609 17.7211 -13.4776 12.334 6.09844 +1808 4 31.8527 35.7258 18.2497 13.1847 15.6537 3.27409 +1809 6 22.1093 41.055 5.1451 11.5479 29.9587 -53.8497 +1810 4 22.1004 40.5969 5.93279 -2.68624 -33.8843 55.363 +1811 4 22.7885 40.6204 4.60559 -4.38419 0.844423 3.37931 +1812 6 11.6153 5.16618 29.5584 -27.6475 13.1782 12.6346 +1813 4 12.1606 4.37097 29.6057 -8.91967 -2.9702 4.15115 +1814 4 10.7377 5.1092 30.0631 35.581 -10.2726 -16.0904 +1815 6 13.0239 9.45481 21.0754 -25.8377 -26.1508 -25.9824 +1816 4 13.6778 9.97234 21.4999 31.652 16.6928 15.5055 +1817 4 13.4195 8.72209 20.5617 -0.589626 12.3395 6.44381 +1818 6 12.4227 4.1736 0.163828 29.6522 45.8695 -12.8421 +1819 4 12.6651 3.77524 1.00427 0.341759 -1.42745 2.51987 +1820 4 13.0617 4.97102 0.020112 -31.9214 -41.0145 4.8633 +1821 6 45.168 14.6284 28.1023 4.783 -10.4532 13.0266 +1822 4 45.253 14.8969 27.1759 8.39119 -6.85383 -0.732919 +1823 4 45.9575 14.0916 28.3529 -13.3622 13.2892 -14.7888 +1824 6 52.571 19.2551 0.894665 -6.12931 -19.318 2.27414 +1825 4 52.6102 19.199 41.8388 0.592413 0.00811024 1.08479 +1826 4 52.8129 20.1442 1.11528 6.55776 18.4237 2.43046 +1827 6 0.161625 18.5694 30.5785 -3.0227 0.535636 4.36465 +1828 4 0.968981 18.7291 30.0798 6.18464 -7.16445 -2.53371 +1829 4 54.7907 19.4514 30.677 -10.8229 5.89199 6.00525 +1830 6 17.6528 28.1849 1.96402 -7.28907 9.7522 11.2687 +1831 4 16.9769 28.8628 1.74785 9.23997 -9.27082 -2.31394 +1832 4 17.6006 28.1534 2.93661 3.56557 1.38454 -8.44201 +1833 6 22.5099 30.1653 5.01109 -1.02808 20.8676 -0.473944 +1834 4 23.1753 30.1014 4.30975 -2.49536 -9.56192 4.09657 +1835 4 22.058 29.3206 5.04766 -1.45363 -6.71999 -4.50103 +1836 6 11.4023 8.80853 17.6459 -26.9993 9.53928 -4.75555 +1837 4 11.8645 8.1762 18.2108 15.3222 4.18532 1.52515 +1838 4 11.9865 9.48216 17.2519 4.47877 -12.4161 10.2871 +1839 6 32.2917 3.59674 26.8117 35.3382 32.7507 -4.14644 +1840 4 31.8458 3.34967 26.0065 -10.4154 -4.5889 -14.8452 +1841 4 32.8806 4.37505 26.5671 -21.1848 -26.3524 0.379863 +1842 6 26.835 37.1568 15.6529 -0.874066 14.8773 29.2405 +1843 4 26.7488 37.4766 16.567 0.376185 8.65421 -15.6923 +1844 4 26.6891 36.2303 15.7909 -0.851881 -23.4278 -14.9094 +1845 6 22.9473 3.40289 22.286 14.7574 -3.5158 -4.23343 +1846 4 23.2792 2.98888 21.4515 -4.53852 7.92848 16.4552 +1847 4 23.7307 3.68139 22.8048 -11.9145 -5.32443 -10.4265 +1848 6 14.6269 28.2214 5.19572 6.06687 6.51489 2.87291 +1849 4 14.1454 28.1555 4.36712 -3.39073 -3.27129 -8.45242 +1850 4 14.2747 28.9991 5.64824 0.61258 -1.12864 1.62503 +1851 6 20.2538 37.2031 16.5466 -28.2562 5.81675 18.2866 +1852 4 21.1004 37.4666 16.2032 21.0823 8.59207 -3.85991 +1853 4 20.0754 37.7549 17.3418 4.82626 -5.93036 -10.2325 +1854 6 17.9544 28.5616 23.889 16.4449 -8.57642 -4.83649 +1855 4 18.808 28.1928 23.5683 -20.3084 2.86715 8.85187 +1856 4 17.2559 27.9215 23.6535 6.51898 5.694 -2.26134 +1857 6 33.646 24.2349 25.2286 -4.54069 1.10679 -14.8717 +1858 4 33.6591 23.269 25.0602 3.54988 10.512 10.2941 +1859 4 34.0237 24.3938 26.1034 0.864522 -9.38336 -2.59148 +1860 6 9.98122 17.6138 2.21344 7.43797 -27.5786 -7.49496 +1861 4 10.832 17.5317 1.73219 -10.6429 3.93943 7.97636 +1862 4 9.86311 16.7639 2.69719 0.409905 15.8492 -4.6087 +1863 6 24.3357 36.801 8.92185 2.98992 -6.60779 12.1866 +1864 4 24.0742 37.6409 8.56425 -5.30422 15.3919 -5.44039 +1865 4 24.7315 37 9.77917 -2.43549 -6.6012 -3.30269 +1866 6 14.4004 4.29557 27.7519 47.583 -3.32523 5.14754 +1867 4 15.335 4.40276 27.3948 -30.4143 -4.44284 13.8265 +1868 4 13.81 4.42145 27.0177 -13.2435 3.17509 -11.8406 +1869 6 13.214 25.4576 35.3169 -22.1271 -24.6319 4.29258 +1870 4 13.1587 25.1592 36.2444 11.1778 9.47444 -6.90086 +1871 4 12.4637 24.9943 34.8985 11.1514 12.2923 -1.08233 +1872 6 43.7301 33.1781 24.4042 -1.93578 -20.5981 16.0744 +1873 4 44.3223 32.959 25.1725 -10.0543 8.3706 -19.7015 +1874 4 44.0713 33.9344 23.9169 6.22405 5.02536 3.22562 +1875 6 6.9686 30.4099 7.14637 29.0056 7.39031 21.9321 +1876 4 6.75777 29.9621 7.98042 -5.17066 0.417247 -5.37485 +1877 4 6.23168 30.2842 6.57126 -23.4728 -6.8193 -11.7975 +1878 6 44.4308 39.4237 21.7855 -4.33275 0.914597 7.54549 +1879 4 43.8654 38.932 21.1541 10.179 9.64354 2.62582 +1880 4 45.001 40.0603 21.3196 -6.51882 -12.4268 -7.79327 +1881 6 1.18424 16.4398 24.9903 -32.4903 25.5998 2.59769 +1882 4 0.976951 16.9992 24.2076 17.4753 -17.2203 8.72915 +1883 4 0.385168 16.6115 25.5394 23.4019 -14.126 -4.16352 +1884 6 8.17355 33.8284 10.6836 -2.7688 -6.92624 14.1509 +1885 4 8.34263 33.4451 9.83813 20.7133 -1.8248 -25.0865 +1886 4 7.32622 33.4212 10.8229 -22.0824 -0.650197 20.9959 +1887 6 45.3734 15.866 40.492 8.57481 -12.1553 -4.93844 +1888 4 44.519 15.6937 40.0698 -0.240559 4.546 7.41406 +1889 4 45.2892 16.6061 41.0987 -5.95018 0.957053 0.609678 +1890 6 38.79 4.28815 15.8976 0.37918 -2.10791 -10.8791 +1891 4 39.6838 3.98516 16.099 -1.14178 2.00828 6.51653 +1892 4 38.4576 4.71748 16.7012 5.69678 -4.45181 -3.36891 +1893 6 21.0946 9.20757 23.9781 -15.5567 7.8487 -28.256 +1894 4 20.9171 8.74785 23.1381 12.0597 -4.77706 12.6228 +1895 4 20.522 9.98378 23.8483 8.03519 -2.74416 16.612 +1896 6 6.47513 36.1489 20.0112 1.62078 -0.443995 1.26518 +1897 4 5.91587 35.3892 19.7749 1.1588 6.62155 -0.72477 +1898 4 7.29927 35.7814 20.3561 -3.99682 -1.77997 -1.59627 +1899 6 17.7466 23.4563 11.2529 28.5847 -29.2717 26.027 +1900 4 17.0283 23.9723 10.9251 -27.3158 17.875 -1.49359 +1901 4 17.6201 23.2782 12.2162 -8.22502 9.28058 -23.7318 +1902 6 2.23619 39.2644 23.5388 49.8561 -28.1857 -22.6679 +1903 4 2.97831 38.9599 24.1359 -27.9038 8.524 -11.8523 +1904 4 2.61824 39.0932 22.6246 -22.7997 11.7085 33.9524 +1905 6 21.7216 10.3211 3.08421 -18.2449 14.4951 30.0936 +1906 4 21.8041 10.0076 2.215 15.0715 -18.3252 -42.7176 +1907 4 20.7597 10.3501 3.18369 2.1836 1.89441 6.77029 +1908 6 13.3346 37.6456 26.8309 31.2085 -13.7023 -2.95714 +1909 4 12.8405 36.9633 27.2803 -9.16641 -7.21061 8.74396 +1910 4 14.167 37.1703 26.5501 -23.1686 18.0804 4.61389 +1911 6 45.6739 9.85296 8.82966 10.4005 6.57186 1.33947 +1912 4 45.3411 9.70411 7.93855 -5.0879 -2.60549 -0.62074 +1913 4 45.1871 9.30295 9.44221 -8.90854 -6.98805 -1.17873 +1914 6 39.813 32.3454 29.581 6.89703 -12.1014 5.95535 +1915 4 39.6485 31.4219 29.3549 -7.08038 -1.01192 -10.7476 +1916 4 40.3223 32.2375 30.3827 0.600223 8.34958 5.32896 +1917 6 39.1399 32.1558 8.97291 22.8595 -6.45003 -40.3239 +1918 4 39.6086 32.0592 8.09926 -10.5081 2.64219 35.3633 +1919 4 38.2198 32.2158 8.71089 -7.955 1.72328 8.07951 +1920 6 29.7568 11.3071 40.3305 36.1908 -28.2332 -10.1569 +1921 4 29.0987 10.6276 40.5022 -6.8613 -0.261357 1.73371 +1922 4 30.5966 10.7518 40.2867 -25.0211 23.0598 -1.19829 +1923 6 24.8367 19.8778 29.8512 -3.76004 22.8831 22.3698 +1924 4 24.8428 19.0032 30.2276 -1.20959 -17.1847 2.11456 +1925 4 24.5914 20.4528 30.618 6.24059 -13.3215 -18.0816 +1926 6 50.0702 29.4819 2.87168 7.70946 6.50978 -10.1722 +1927 4 50.8345 29.4231 3.46787 -5.92296 0.441099 -8.02421 +1928 4 50.4135 29.3271 1.96617 -11.3825 0.248157 19.2026 +1929 6 26.3309 13.2577 37.9673 -13.8105 -3.9786 -34.6653 +1930 4 27.2227 13.0528 37.6163 -4.21147 3.58808 27.148 +1931 4 26.2568 13.475 38.8976 18.37 3.27206 13.6317 +1932 6 24.3356 13.8068 16.1475 3.59325 -0.347239 -0.208698 +1933 4 24.7367 14.1162 16.9522 4.68271 -6.41054 14.6744 +1934 4 24.1923 14.631 15.6832 -6.43367 3.48529 -13.6665 +1935 6 21.9593 25.0956 8.01078 27.9223 3.76027 7.52529 +1936 4 22.6404 25.6041 7.51239 -14.7718 -5.75747 5.32796 +1937 4 22.4795 24.6555 8.71494 -11.0917 7.59151 -10.9937 +1938 6 50.1732 25.2931 29.034 -22.8769 -27.0861 -14.4889 +1939 4 50.9231 25.1249 28.4453 9.52927 7.92169 5.9345 +1940 4 50.3853 25.9631 29.6741 16.3661 14.9722 8.20298 +1941 6 23.1854 6.82331 7.6223 5.22953 23.7057 -4.54178 +1942 4 23.9785 7.3899 7.84298 -26.8007 -12.7469 -6.01791 +1943 4 22.4118 7.42329 7.468 18.2581 -13.076 4.30509 +1944 6 6.92213 5.8571 20.8332 2.72627 6.95854 -11.5419 +1945 4 7.54915 6.58218 20.6217 -11.8273 -13.0803 1.39721 +1946 4 6.56012 5.53917 19.9848 5.57208 -2.46181 7.62025 +1947 6 25.395 39.7583 23.949 6.36773 8.3837 -46.9746 +1948 4 25.6324 38.8356 24.0083 0.522678 -6.92882 12.1803 +1949 4 25.626 39.9451 22.9935 -8.38215 2.07882 31.2615 +1950 6 10.8464 30.695 2.12273 2.92699 -11.4721 29.0623 +1951 4 9.93667 30.8598 2.41274 2.41412 3.42254 -4.79395 +1952 4 11.0072 31.0743 1.26994 -5.60296 10.8359 -22.248 +1953 6 23.0784 40.5299 40.0517 -12.8303 7.3127 -19.6888 +1954 4 23.7801 40.7079 39.3995 -2.98216 -3.06267 5.67195 +1955 4 22.2752 40.9489 39.6621 13.0026 -6.04267 8.58422 +1956 6 29.2116 28.3822 37.564 -38.7174 33.0362 -17.1388 +1957 4 28.2182 28.3913 37.3962 39.4392 -4.09178 7.25715 +1958 4 29.4217 27.5495 37.9564 8.20519 -19.4736 9.10227 +1959 6 1.867 12.1738 18.0852 -6.50713 5.08339 -35.4355 +1960 4 2.57398 11.838 18.6163 6.10024 -5.16113 22.8519 +1961 4 1.13063 12.5086 18.5994 -2.48645 -2.83143 13.3981 +1962 6 35.8305 14.0949 8.56039 26.0881 18.3061 13.156 +1963 4 35.1714 13.4739 8.88749 -16.8661 -4.96187 -13.4504 +1964 4 35.7684 14.4109 7.636 -16.9096 -16.2229 2.78164 +1965 6 9.49198 39.8165 37.5846 25.5398 -19.6342 8.10058 +1966 4 10.4488 39.5668 37.3792 -35.3087 19.1509 -1.98674 +1967 4 9.11285 40.4907 37.0027 15.1686 -3.88151 -5.41116 +1968 6 3.54864 30.3444 19.2746 19.2588 -4.84534 25.5649 +1969 4 4.39288 30.8221 19.2218 -5.35887 2.33403 -8.35831 +1970 4 3.69938 29.8 20.0823 -8.98886 6.07327 -15.723 +1971 6 36.3172 32.3761 17.5568 -52.716 -14.5505 -10.7859 +1972 4 37.1181 32.7413 17.8285 45.3049 23.5946 19.1732 +1973 4 36.5447 31.7674 16.8589 0.0557097 -8.91784 -8.34906 +1974 6 22.0674 24.5243 41.4066 13.5104 10.4808 14.5301 +1975 4 21.9193 25.2614 0.114872 1.55544 -1.48024 -5.36737 +1976 4 21.3782 24.5469 40.7428 -11.5581 2.78113 -8.36201 +1977 6 45.7659 15.6016 11.6394 9.02046 4.78635 -7.96304 +1978 4 46.6299 16.0103 11.8091 -2.50167 -1.58301 0.968075 +1979 4 45.9087 14.6499 11.5698 3.7439 -8.72722 -0.994242 +1980 6 22.3679 20.3809 16.0361 -10.6504 -17.4294 -19.3744 +1981 4 21.763 20.3139 16.7773 -4.42579 5.53693 13.3566 +1982 4 23.0073 21.0579 16.2253 11.6801 17.1208 13.2616 +1983 6 25.8325 25.7487 18.9031 6.26908 13.5994 -10.9759 +1984 4 25.2398 26.4837 18.648 3.49723 -12.6326 6.8661 +1985 4 25.3435 25.2434 19.5576 -3.6765 -3.23145 -0.768961 +1986 6 35.3178 34.202 33.2905 -17.6504 -29.1706 1.13026 +1987 4 35.3983 35.1402 33.2641 1.24044 29.706 -1.15043 +1988 4 34.4344 34.0427 33.6774 7.05439 -0.467604 -1.03347 +1989 6 39.2901 17.1075 17.3833 -11.3112 -26.2042 -1.68945 +1990 4 39.9794 17.7123 17.5836 17.425 19.0869 4.79839 +1991 4 38.575 17.6263 16.9966 -1.50153 2.1098 -0.940241 +1992 6 0.398412 14.9432 21.7856 9.03058 1.70326 -1.90296 +1993 4 54.4474 14.9193 21.5731 -3.898 -0.019948 -1.7993 +1994 4 0.528431 14.174 22.3634 -0.170355 0.861544 -0.399335 +1995 6 15.987 23.2263 17.7743 4.36624 14.6934 -7.14303 +1996 4 15.4857 22.9799 16.9684 3.82047 1.22984 7.38673 +1997 4 16.1722 24.1939 17.7179 -4.44652 -15.4901 1.96988 +1998 6 5.24865 11.1141 17.5618 6.95422 37.8037 -9.42255 +1999 4 4.73778 10.3127 17.5906 4.69561 -15.2682 10.3552 +2000 4 6.07662 11.1201 18.0866 -14.6292 -19.4463 0.240297 +2001 6 9.34435 36.7122 13.2675 14.3848 -20.4853 -8.45434 +2002 4 9.62142 35.7704 13.1913 -3.31983 12.7393 -0.467066 +2003 4 9.65952 37.1602 12.4706 -4.49166 -2.86228 3.29419 +2004 6 25.4918 33.5767 0.585194 -13.2513 47.819 -13.0434 +2005 4 25.5067 34.5261 0.924259 2.87868 -31.0124 -5.96193 +2006 4 25.9276 33.0244 1.21144 10.5779 -12.847 23.4116 +2007 6 17.3034 24.3894 31.3332 -3.83374 11.0726 -5.16798 +2008 4 17.6693 25.1812 30.9068 -1.9735 -3.85303 -0.254684 +2009 4 16.6127 24.6926 31.9382 -2.66612 -1.73239 2.61398 +2010 6 50.552 32.7161 27.7939 3.69414 -2.86079 -12.6149 +2011 4 50.6897 33.0491 28.6758 -0.144502 8.45372 13.0825 +2012 4 49.6264 32.8868 27.6344 -12.0524 -1.73095 -4.05681 +2013 6 2.253 37.2274 16.11 8.45807 0.136394 4.49883 +2014 4 3.21927 37.2459 16.107 -3.10104 -5.97474 -11.5471 +2015 4 2.06307 37.5747 16.9848 -8.61924 1.9026 3.91491 +2016 6 25.7683 33.176 8.40354 -18.9203 -11.3347 4.07551 +2017 4 24.8717 33.1921 8.8134 13.9609 -2.48357 -8.81655 +2018 4 25.7602 32.4226 7.7918 -3.67744 3.53954 1.65329 +2019 6 24.768 7.83219 25.4219 17.632 21.1734 16.2998 +2020 4 25.4945 8.36147 25.0103 -20.1597 -14.0103 5.71998 +2021 4 24.2535 7.44908 24.728 -12.2137 -5.73332 -20.4071 +2022 6 44.006 27.3325 21.546 30.1554 -7.9652 -11.3918 +2023 4 43.2457 27.8583 21.7575 -19.7371 1.57643 -2.46296 +2024 4 43.7964 26.4976 21.0884 -11.5694 12.3441 5.98804 +2025 6 20.8391 32.0716 6.72617 12.9902 -8.35788 -26.5741 +2026 4 21.6065 31.456 6.61879 -16.2643 13.1482 10.0653 +2027 4 20.6646 32.3142 7.64123 9.40483 -3.67012 8.54308 +2028 6 0.615177 26.1024 3.99379 -2.52029 5.686 8.70358 +2029 4 0.872898 25.4419 3.3518 0.34785 -8.86692 -8.8337 +2030 4 1.24928 25.9906 4.70547 -1.00806 2.16518 1.82635 +2031 6 23.6932 0.22266 22.8575 19.6208 -9.09848 8.51526 +2032 4 23.2991 1.09802 22.9795 5.26519 -2.66393 -0.960482 +2033 4 24.6108 0.216177 23.2468 -26.6208 7.90328 -9.41734 +2034 6 35.6316 26.9489 6.47476 -11.9227 4.67096 -7.07616 +2035 4 36.2784 26.7656 7.18499 -0.847143 10.2035 -9.59556 +2036 4 35.6247 27.8854 6.12936 11.6979 -23.4314 22.5499 +2037 6 50.1669 7.09081 18.6924 -7.14542 -1.6973 -3.47771 +2038 4 50.8011 7.27946 17.9805 -1.08143 -0.293524 0.841141 +2039 4 49.7425 7.94753 18.8476 4.63932 0.367722 -3.05405 +2040 6 12.4741 14.8288 12.1922 -8.10271 -9.61402 10.4649 +2041 4 11.6958 14.4794 12.6802 13.1948 7.08912 -7.97814 +2042 4 12.1183 15.3251 11.4609 -4.91784 2.70917 -6.99785 +2043 6 52.4614 22.3688 36.3388 -11.0199 -17.3524 -23.0567 +2044 4 51.6251 21.9183 36.1306 -2.17212 11.6706 13.3338 +2045 4 52.9952 21.963 35.6316 8.38603 12.1418 11.4133 +2046 6 41.778 11.4842 39.1192 -2.94788 -8.5466 -71.3066 +2047 4 42.0712 11.6935 39.9642 18.9262 14.1801 48.2999 +2048 4 42.4688 11.7778 38.472 -13.5225 -5.5757 18.7019 +2049 6 13.7869 22.5139 39.1025 -32.0544 -7.10206 -10.9841 +2050 4 12.8164 22.2898 39.2995 40.1723 6.0649 -15.4789 +2051 4 14.0276 22.2847 38.1645 -11.932 2.241 24.8997 +2052 6 28.7471 19.519 21.8427 26.201 -31.4587 -3.42241 +2053 4 29.5077 18.8642 21.7553 -27.3151 19.4313 7.21597 +2054 4 28.709 19.939 20.977 -1.33904 3.86677 -3.41873 +2055 6 8.35104 21.6464 36.3873 -9.70021 11.1463 1.78198 +2056 4 8.59231 22.5715 36.3877 5.92817 6.74417 -5.91108 +2057 4 7.6521 21.6323 37.0621 1.10663 -7.27579 -5.05072 +2058 6 39.9466 23.9759 15.2079 21.5993 -7.98015 -41.1742 +2059 4 40.8727 23.6245 15.2724 -23.8836 11.1149 -0.884493 +2060 4 39.7538 23.9548 14.2182 -0.675121 3.14563 34.0025 +2061 6 8.14826 38.6974 22.5407 10.5164 -8.10765 28.5856 +2062 4 7.68497 39.3831 22.0542 -4.5186 11.15 0.90042 +2063 4 8.43687 39.0737 23.4204 -11.1896 -2.29822 -22.518 +2064 6 10.8609 20.1732 28.9608 12.8413 -0.923384 7.34695 +2065 4 10.0131 19.7426 29.0637 -5.9523 -4.47565 4.1188 +2066 4 10.8844 20.5008 28.0696 -0.703946 5.19258 -12.1525 +2067 6 36.9008 23.822 41.8156 -12.4363 21.7846 -10.0393 +2068 4 37.5711 23.2333 0.167128 40.9996 -19.7248 12.2972 +2069 4 36.1173 23.3131 41.9445 -23.6506 -5.40851 2.0223 +2070 6 23.7894 40.6868 33.3454 12.8596 -15.6087 -7.6142 +2071 4 23.0064 40.9655 33.8068 -12.9523 11.6172 4.83708 +2072 4 23.8763 39.7481 33.6232 3.5481 12.5289 -6.50269 +2073 6 4.67002 19.3025 35.4081 28.9654 -8.37802 15.8464 +2074 4 5.50304 19.0977 35.9037 -20.926 10.8248 -6.78781 +2075 4 4.54874 18.5079 34.879 -7.50763 -2.93955 -6.02594 +2076 6 9.44906 25.7726 10.897 4.32597 -4.58851 8.60165 +2077 4 9.18995 24.8319 10.8983 -5.5655 4.98255 -0.925486 +2078 4 8.69969 26.3126 10.6078 0.159443 -6.7376 0.514864 +2079 6 27.2776 22.4912 13.6121 -0.517147 -7.99313 -8.85992 +2080 4 27.155 21.7331 14.2088 0.0551372 2.14825 -2.63665 +2081 4 27.5226 22.1158 12.7439 -1.12325 6.52643 14.1544 +2082 6 41.0473 18.7721 23.2805 -1.65607 -7.19044 -7.91226 +2083 4 40.4257 18.2083 22.8124 7.09703 -3.21037 0.549063 +2084 4 40.4899 19.4448 23.6465 -2.2525 13.4867 10.2584 +2085 6 46.4847 28.3568 20.1596 21.4343 7.62243 20.4812 +2086 4 45.6558 28.0725 20.6313 23.6124 6.3397 2.68094 +2087 4 47.3103 28.4552 20.7557 -43.4876 -6.08109 -17.1535 +2088 6 14.856 15.3945 30.0569 12.1054 -1.48105 24.8406 +2089 4 14.6669 15.4041 29.1302 -8.67008 -4.83168 -20.7775 +2090 4 14.3859 14.629 30.4429 4.17574 5.50589 -6.96103 +2091 6 23.5299 24.7674 35.2089 8.01546 19.7663 24.3744 +2092 4 22.8065 25.3632 35.4756 2.8295 -9.26237 -7.23473 +2093 4 24.1647 24.8645 35.9517 -5.58112 -4.18239 -8.07128 +2094 6 19.8979 24.2128 28.4372 -8.55524 33.371 -10.5251 +2095 4 20.118 25.106 28.0235 -7.554 -30.7898 14.4583 +2096 4 18.9386 24.2465 28.5992 8.91169 -0.342387 -2.75065 +2097 6 45.9653 7.62821 20.2375 0.645938 -6.46631 40.9505 +2098 4 46.1455 7.81465 21.2011 -4.75538 -9.14986 -26.6761 +2099 4 46.2053 8.42523 19.7798 3.02803 13.7202 -10.1214 +2100 6 38.0274 12.476 8.2804 -12.7973 12.3245 -4.6187 +2101 4 37.3544 13.1993 8.5286 18.4233 -41.2645 -20.6098 +2102 4 37.689 11.8001 7.60922 -1.16355 31.2483 23.3325 +2103 6 46.9232 18.1908 8.45127 -20.6048 6.85227 14.7641 +2104 4 46.2435 17.4987 8.55233 4.56757 4.50302 -0.225601 +2105 4 47.4224 17.9381 7.68168 11.4282 -5.99968 -17.9171 +2106 6 10.854 13.9656 9.37577 10.6617 18.3473 -18.9154 +2107 4 10.3554 14.661 8.90618 -4.87744 -10.6328 11.7585 +2108 4 11.7492 14.0754 8.99486 -7.79483 -7.36366 10.4335 +2109 6 34.413 5.42618 14.0852 -12.6861 0.159125 26.6885 +2110 4 35.1199 5.9296 13.6715 10.4361 -4.78744 -13.6438 +2111 4 34.2786 4.53955 13.7091 11.464 2.02167 -7.62295 +2112 6 0.18261 0.234369 22.9555 2.77695 -16.1069 -0.480131 +2113 4 0.268342 41.6651 22.1144 -0.0234796 4.94264 7.55149 +2114 4 54.831 1.09037 22.7433 -8.12427 18.964 -5.90735 +2115 6 40.9343 30.5497 37.8912 -0.822728 -5.40818 -2.29365 +2116 4 40.0406 30.8803 38.1728 23.6728 -16.1598 5.2797 +2117 4 41.3254 29.8415 38.4693 -14.8835 20.0143 -6.13723 +2118 6 16.6534 17.3205 12.6874 14.7099 15.3782 -9.06546 +2119 4 16.1954 16.505 12.4572 -1.18797 -4.10455 -0.493236 +2120 4 17.006 17.6533 11.8352 -5.05849 -6.69802 12.8635 +2121 6 29.6898 5.4323 24.749 -0.0153423 -4.79708 -9.00604 +2122 4 30.3311 5.93507 24.2276 2.5605 1.293 3.45927 +2123 4 29.9547 5.54756 25.6733 0.859724 2.70473 -2.20341 +2124 6 49.8976 0.279 27.2063 11.3554 -10.6099 9.68168 +2125 4 49.8114 0.578981 26.2935 2.75523 0.634109 -3.06626 +2126 4 50.8097 41.8349 27.2847 -10.6363 5.42595 -5.44518 +2127 6 31.2372 31.739 15.2138 3.99594 22.7956 -4.27207 +2128 4 31.6256 30.8953 15.4507 4.79789 -4.71254 6.82751 +2129 4 31.9624 32.4004 15.1381 -14.4355 -14.737 3.33184 +2130 6 35.7805 24.1465 16.9504 11.9916 -3.59376 -8.04525 +2131 4 35.6914 24.9231 16.3572 2.28972 -11.6943 5.94213 +2132 4 36.6882 23.763 16.8157 -19.8391 7.30154 4.46135 +2133 6 24.2601 4.62781 36.7306 -2.73038 -12.1142 -21.0154 +2134 4 24.8177 5.17448 37.2794 5.25293 5.76293 7.44764 +2135 4 24.6802 4.67277 35.8537 -9.35577 -2.69704 9.81341 +2136 6 17.5719 12.8989 3.66466 27.7221 -13.8379 -12.2911 +2137 4 17.7111 13.5231 2.92461 -8.26776 -5.83385 13.2655 +2138 4 16.7968 13.1561 4.15408 -15.8703 8.33112 4.7305 +2139 6 4.16771 14.2922 18.2601 -1.91899 -29.1082 -10.1028 +2140 4 4.22837 13.3107 18.2109 4.90834 19.7408 -0.578384 +2141 4 3.27435 14.4381 18.5824 -9.9871 6.86755 4.44487 +2142 6 19.1699 36.8381 22.3902 -4.55286 10.0742 -5.97046 +2143 4 18.832 36.3461 23.1414 -4.92402 -9.67799 11.164 +2144 4 19.5712 36.1952 21.8056 6.33502 -12.5333 -3.55186 +2145 6 15.653 11.96 13.2084 19.351 18.6963 0.185202 +2146 4 15.6609 12.833 12.7547 -2.35489 -19.4305 9.56752 +2147 4 16.5767 11.8359 13.5469 -18.24 -1.16426 -6.81767 +2148 6 24.7461 21.9204 5.38797 -27.1503 3.38708 1.08719 +2149 4 25.0422 21.7466 6.29562 -9.42613 0.489783 0.293639 +2150 4 23.7615 21.7936 5.33342 31.5349 -1.60743 10.1723 +2151 6 52.731 18.5617 35.2291 -23.3227 -9.96089 -3.35821 +2152 4 52.3432 18.0885 34.4925 12.0283 -8.22578 -16.7439 +2153 4 51.9379 18.6142 35.7503 -4.18579 12.1235 24.3517 +2154 6 3.56339 27.2782 25.2861 -13.9068 -17.971 -11.9546 +2155 4 3.93933 27.1708 26.1554 6.48024 -2.07304 15.4908 +2156 4 3.97283 28.0403 24.8958 8.97188 17.1762 -5.24442 +2157 6 34.4703 32.9949 30.674 6.71734 26.132 41.1649 +2158 4 33.5303 32.9277 30.8218 -10.267 -13.4259 -20.1884 +2159 4 34.6757 33.5653 31.4552 13.6938 -14.1125 -21.2315 +2160 6 35.2703 23.7477 9.841 1.59588 4.98779 0.126485 +2161 4 34.557 23.9691 9.22977 0.987563 3.83206 0.754652 +2162 4 35.6213 22.923 9.5082 6.82753 -10.3388 -1.5208 +2163 6 42.4139 15.7114 8.97964 24.1102 0.334397 4.42901 +2164 4 41.6569 15.4185 8.4899 -23.1764 -3.9339 -8.15459 +2165 4 42.1019 15.9745 9.85446 -9.30455 -0.897043 1.06511 +2166 6 7.76859 28.8573 32.9442 -15.9037 16.0354 -10.4898 +2167 4 7.97908 28.1549 33.5519 6.36032 -10.9608 11.0673 +2168 4 8.54203 29.0732 32.4131 7.8922 -1.0693 -1.41065 +2169 6 17.6887 41.2397 36.4833 -13.2152 -10.2381 33.1554 +2170 4 16.9194 41.8027 36.6113 -2.7651 1.17246 3.809 +2171 4 17.9462 41.408 35.602 16.1966 5.46369 -29.7656 +2172 6 28.4973 24.2486 15.5471 -12.6583 -10.112 -30.4241 +2173 4 29.1017 24.9078 15.1992 6.65529 6.29726 4.69488 +2174 4 28.2904 23.7156 14.7389 1.39534 3.17619 21.4563 +2175 6 20.9519 16.2974 1.15248 44.1264 9.982 -6.69009 +2176 4 20.9895 15.4004 1.43432 -0.0798072 -22.9414 11.198 +2177 4 20.0538 16.5254 1.09156 -44.6028 7.62895 -2.50253 +2178 6 31.1717 40.7384 5.29995 -1.14335 -24.9234 -14.6262 +2179 4 30.3101 40.4535 4.98914 0.542473 -7.39845 -0.335603 +2180 4 31.0069 41.6267 5.54556 -2.10438 36.1837 12.2935 +2181 6 29.9172 24.7601 36.4536 2.52587 12.7881 -5.39704 +2182 4 30.4095 25.4459 35.9567 -7.35112 -4.48214 8.13095 +2183 4 30.0744 23.9625 35.9621 2.47343 -16.947 -5.4104 +2184 6 8.66853 31.0461 3.90506 3.77884 -22.5587 -9.29968 +2185 4 7.73756 30.8263 3.92016 -7.28297 1.54323 -1.95967 +2186 4 8.75192 31.9258 4.24445 1.80419 26.3875 10.0131 +2187 6 5.53845 32.6958 11.4143 8.71933 -16.8124 -2.49586 +2188 4 4.77303 33.2403 11.6664 3.11219 -11.1916 -2.75881 +2189 4 5.22904 31.759 11.32 0.456358 25.4252 4.80969 +2190 6 45.6505 35.4572 20.4414 3.44959 -7.44503 -2.03407 +2191 4 45.0984 35.4295 19.6379 6.4013 -0.712815 7.57821 +2192 4 46.1919 34.6303 20.4513 -12.6908 13.7486 -3.45541 +2193 6 19.5117 2.78375 9.7759 -32.3978 -9.59039 -17.0694 +2194 4 19.2358 3.70482 9.71872 -0.134373 3.8207 4.89971 +2195 4 18.7417 2.29322 9.36028 25.7327 11.9734 13.3495 +2196 6 54.9587 9.07031 10.9149 6.82732 -5.63024 12.2566 +2197 4 54.8294 8.9199 11.8667 -4.4018 -2.06217 -5.32285 +2198 4 0.663346 9.73371 10.8556 1.49355 -0.124783 -2.42855 +2199 6 21.0387 26.5729 14.7801 20.1883 -1.49652 -44.4677 +2200 4 21.3075 26.2685 13.8316 -13.9911 15.8829 47.28 +2201 4 20.1009 26.3915 14.9175 1.72514 -4.1332 -5.78598 +2202 6 14.1556 30.5195 27.5512 33.9559 3.86758 5.7066 +2203 4 14.6157 30.1887 28.3748 -9.20473 8.28645 -28.3289 +2204 4 14.8625 30.9321 26.9648 -24.7422 -11.1229 20.6028 +2205 6 29.8153 17.3336 31.0863 -17.242 12.2647 2.89366 +2206 4 30.6608 17.508 30.6961 22.1461 -2.37775 -6.86255 +2207 4 29.3509 18.1813 30.9961 -0.156979 -6.11616 8.89085 +2208 6 50.8803 17.2897 27.8178 -36.3925 19.5692 4.68662 +2209 4 49.966 17.6961 27.8739 30.6942 -17.822 -8.40051 +2210 4 51.3989 17.8346 28.4178 4.99425 -5.86793 -0.268148 +2211 6 46.2649 37.0836 13.9834 -5.2064 -3.89214 -29.9265 +2212 4 46.1297 37.5324 14.8008 -1.4234 12.1478 29.9589 +2213 4 45.6025 37.4999 13.3985 5.55615 -7.46483 0.310394 +2214 6 38.1938 37.2652 33.1426 -7.30823 -21.5307 12.8964 +2215 4 38.5245 37.3061 34.0621 0.43181 3.22683 -10.2889 +2216 4 38.5338 38.0078 32.6437 8.99657 15.0472 -1.17828 +2217 6 41.835 13.3432 31.1173 -10.6585 13.9874 21.8211 +2218 4 41.5818 13.8647 31.919 4.55225 -14.0949 -20.2689 +2219 4 42.3932 12.6177 31.4161 6.34511 -7.13184 -1.29627 +2220 6 46.8964 12.6581 17.833 -7.85032 10.4907 -16.4819 +2221 4 46.6484 13.6178 17.7542 4.08188 -24.8978 -7.40371 +2222 4 46.6377 12.1709 16.9987 5.46876 16.7046 19.0746 +2223 6 32.0579 10.0934 10.6503 -8.64381 28.9058 -4.43215 +2224 4 31.7849 9.65569 11.4853 0.173068 15.3159 -11.0765 +2225 4 31.7767 11.0763 10.6467 12.4785 -48.8318 10.7993 +2226 6 34.0094 11.373 6.75969 12.8388 24.8548 11.4886 +2227 4 33.4875 10.5861 6.69386 -15.1181 -21.0438 1.83339 +2228 4 33.7853 11.7772 7.62543 1.85262 -6.17932 -11.7084 +2229 6 45.3294 30.8612 19.494 8.3992 -12.4908 2.66791 +2230 4 45.3133 30.6326 20.4263 -2.2594 2.91399 10.7741 +2231 4 45.8271 30.1094 19.1443 -2.81922 5.63857 -5.34771 +2232 6 20.3557 0.57205 7.14927 -0.865045 4.87397 8.36509 +2233 4 20.1887 0.590785 8.10086 -2.30268 5.48708 -2.96522 +2234 4 20.2885 41.5556 6.94299 -1.24307 -13.5357 -7.1472 +2235 6 15.9783 39.4524 4.13892 -0.0151964 -9.48015 -5.29824 +2236 4 15.6158 39.9898 3.41173 1.6648 1.85694 12.5404 +2237 4 15.64 39.7774 4.99485 -4.20756 5.15612 -10.0141 +2238 6 52.4256 16.4667 25.1127 -17.0507 13.8269 -2.02364 +2239 4 51.8848 16.9346 25.7614 0.982734 -7.60925 5.82434 +2240 4 52.3383 17.0704 24.353 8.48557 -12.5426 -0.219872 +2241 6 38.5361 13.0039 3.23845 15.1533 54.069 38.768 +2242 4 38.651 13.64 4.04305 -2.16968 -28.4467 -44.0011 +2243 4 38.0019 12.309 3.58724 -16.6469 -22.8542 0.297491 +2244 6 35.13 29.6899 31.1766 -32.8294 1.63854 50.8714 +2245 4 35.4825 30.1651 30.4465 16.0479 15.276 -26.3528 +2246 4 34.6741 30.3613 31.7643 12.1102 -21.125 -19.7306 +2247 6 9.51973 33.7498 4.86217 -21.8826 5.77433 4.68556 +2248 4 9.27059 34.3826 5.57285 8.50621 -13.5655 -12.6408 +2249 4 10.3866 33.3952 5.041 8.90701 -1.44023 3.12186 +2250 6 21.534 22.0642 20.5279 -11.3341 -5.53839 17.2976 +2251 4 20.8989 22.7675 20.339 3.51908 1.76985 -0.685914 +2252 4 21.3133 21.7346 21.437 6.74336 6.48682 -22.5749 +2253 6 37.579 11.1901 41.2936 -40.5688 -13.8213 19.6839 +2254 4 37.9154 11.8125 40.6731 20.8822 18.4609 -22.3708 +2255 4 38.2848 10.6639 41.6667 19.2795 -3.39896 1.21846 +2256 6 33.8862 1.42431 38.7362 -9.76991 -12.243 -0.11253 +2257 4 33.6023 0.553369 38.4181 2.20193 5.31751 1.25532 +2258 4 33.9041 1.3558 39.7008 -0.574955 5.51976 -3.65617 +2259 6 4.57166 26.6812 27.9899 28.8485 -45.5436 -4.48952 +2260 4 5.15229 25.8908 28.1565 -23.3183 20.9594 -13.553 +2261 4 4.90489 27.293 28.6243 -0.866291 24.6335 11.5543 +2262 6 10.2514 0.902381 11.6154 -4.58149 -17.6537 26.8062 +2263 4 10.6592 1.12475 12.4668 -4.26503 -7.612 -8.38981 +2264 4 10.5004 1.60734 11.0484 5.83944 23.9466 -26.0443 +2265 6 17.6545 19.8255 2.35686 18.7122 -0.118329 6.29025 +2266 4 17.9031 20.43 1.64019 0.754008 -4.0492 2.7955 +2267 4 18.4832 19.3436 2.60738 -15.0404 10.1651 -4.64219 +2268 6 32.418 25.6758 16.4635 3.6076 24.4214 11.9097 +2269 4 33.0171 26.0095 17.1449 -9.06157 4.09224 -4.99535 +2270 4 32.7904 24.838 16.2462 -1.14602 -28.0291 -11.1265 +2271 6 33.2468 10.6359 0.32388 9.93322 -26.76 -6.12289 +2272 4 32.8861 10.0042 41.5485 10.341 19.2926 16.9559 +2273 4 34.0854 10.2367 0.697563 -23.7256 11.8288 -10.1734 +2274 6 4.94758 4.52061 10.1416 10.7499 4.98188 17.9077 +2275 4 4.04768 4.863 10.1726 -0.273394 -4.88493 2.42241 +2276 4 5.29522 4.53942 11.0694 -10.4701 1.63881 -23.2648 +2277 6 27.0943 16.9779 9.5563 -20.4641 3.47693 -11.2288 +2278 4 27.2045 17.5151 10.3493 -1.38601 2.5137 2.70549 +2279 4 26.2214 17.2494 9.17658 21.4447 -4.2653 12.7286 +2280 6 9.99194 10.5198 19.3763 9.42123 -1.05348 44.8422 +2281 4 10.4342 9.89794 18.8118 9.85784 -12.5922 -17.5865 +2282 4 10.1605 10.162 20.3013 -9.67835 15.4527 -31.558 +2283 6 19.5738 8.53792 27.8563 25.8928 -1.13542 15.4327 +2284 4 20.113 8.77024 28.6584 -12.6361 -5.62488 -23.922 +2285 4 20.1113 7.87775 27.3567 -13.5748 14.3815 9.08869 +2286 6 47.0629 38.9588 23.1271 -13.9792 1.44752 0.432651 +2287 4 47.6691 38.8737 22.3925 4.22694 -4.47738 -4.61135 +2288 4 46.1776 38.8683 22.7344 3.33277 3.24373 3.79368 +2289 6 19.6833 25.3678 11.2608 -44.4501 -0.725843 0.650565 +2290 4 19.0139 24.6272 11.3182 24.6346 19.551 -2.60477 +2291 4 19.1544 26.1629 11.5326 10.4738 -19.1562 -5.87093 +2292 6 27.3884 13.4531 15.7313 17.4935 -10.3398 7.87305 +2293 4 26.7289 13.8255 16.2909 -22.225 11.7393 10.4827 +2294 4 28.1076 13.2654 16.3619 5.43008 -3.78237 -14.8549 +2295 6 18.6476 14.1287 1.42435 5.12245 -4.46092 -43.403 +2296 4 18.3969 15.043 1.25229 -6.07889 7.26273 6.76186 +2297 4 19.169 13.9274 0.593091 -12.995 -1.5013 29.2583 +2298 6 42.2956 22.0175 32.4812 -31.5033 5.69606 -11.9689 +2299 4 42.0953 21.6028 33.3343 -5.26012 -0.0861087 1.91793 +2300 4 41.4492 22.4721 32.2087 27.3869 -15.7461 8.96812 +2301 6 10.0338 9.4525 2.5044 21.0744 -25.1182 9.26795 +2302 4 9.23419 9.82009 2.8603 -22.4046 15.9317 4.21557 +2303 4 10.2146 8.68383 3.09556 -0.513225 11.8796 -14.6695 +2304 6 6.81454 1.43994 21.9965 -17.8896 2.42247 -7.4431 +2305 4 5.91626 1.63042 21.618 24.8197 -16.2049 7.25345 +2306 4 7.09146 0.513113 21.8391 -15.5061 11.1514 -4.64506 +2307 6 11.279 27.0428 18.9739 -2.94846 37.5248 -0.887691 +2308 4 11.8405 27.0241 19.773 -2.49358 0.901506 -7.48985 +2309 4 11.2189 28.0198 18.7087 3.35633 -32.7966 13.2637 +2310 6 41.4624 20.5117 27.2131 -8.71247 23.609 -19.3396 +2311 4 41.6397 21.203 27.8749 -2.09795 -12.5822 -0.139714 +2312 4 41.4581 19.6661 27.6488 3.25287 -9.08293 14.2442 +2313 6 15.4472 24.107 33.4286 7.47915 5.78269 -2.8589 +2314 4 14.6947 24.3175 34.0087 6.10264 -6.26217 -2.67023 +2315 4 15.704 23.1687 33.5026 -8.54671 4.87938 10.939 +2316 6 36.1332 16.3778 10.0175 -2.81296 8.13669 8.31829 +2317 4 36.0433 15.4982 9.63146 0.0153009 -3.05325 1.23302 +2318 4 36.1908 16.2895 10.9807 1.05799 -3.5475 -8.17119 +2319 6 51.7056 16.2618 2.12066 8.195 -18.8618 -27.7488 +2320 4 51.3212 16.7491 2.82948 -13.5116 6.32013 30.1636 +2321 4 51.8333 15.3227 2.36395 -2.62212 15.8907 6.5854 +2322 6 23.4154 8.54771 39.774 19.4785 -4.07885 -14.0827 +2323 4 23.6619 8.92799 38.8876 -4.40964 -10.2511 30.1282 +2324 4 24.1933 8.06554 40.1323 -10.8686 15.1901 -10.9325 +2325 6 36.7652 34.4407 21.0996 -10.7203 -4.0633 -8.35763 +2326 4 37.1575 34.5988 20.2292 -2.24352 0.118594 1.89686 +2327 4 35.7922 34.4168 20.9564 13.0606 -0.027129 3.88767 +2328 6 14.1394 8.88964 27.2822 8.4001 33.0473 -16.3093 +2329 4 13.5583 8.17177 27.4325 -25.1847 -27.8879 6.89622 +2330 4 14.9981 8.62308 27.6007 12.278 -0.771553 4.38 +2331 6 20.6523 37.4857 25.1916 -4.76336 -9.80096 2.89409 +2332 4 20.8435 36.6327 24.7231 -2.60537 24.8018 1.29013 +2333 4 20.5883 38.2205 24.557 2.95927 -14.0914 0.587832 +2334 6 28.8259 24.466 30.0361 -12.0182 1.20484 18.6414 +2335 4 28.1863 24.5363 29.306 15.5663 0.0495978 -2.57679 +2336 4 29.6571 24.0617 29.7579 -0.701354 -5.27936 -13.535 +2337 6 8.3767 11.9994 23.6977 15.286 -11.9681 20.7139 +2338 4 9.3753 12.0245 23.8359 -31.6027 -4.22616 -3.50543 +2339 4 7.96209 11.4264 24.4013 16.8905 14.3689 -13.5243 +2340 6 16.0974 26.6628 22.9497 0.767107 4.93659 2.67852 +2341 4 16.422 25.9025 22.452 -4.69466 0.466105 1.02544 +2342 4 15.3072 26.4353 23.4595 5.90508 -1.9072 -2.1838 +2343 6 22.3492 41.3933 9.48833 17.1541 -15.2597 3.14364 +2344 4 22.6076 0.330473 9.13574 5.89797 15.5422 -4.87712 +2345 4 21.4389 41.4869 9.73785 -21.2641 2.73615 1.78898 +2346 6 49.3865 19.1849 32.379 28.5034 -27.5288 -8.8444 +2347 4 49.9591 18.5119 32.8294 -20.0237 22.3317 -7.01358 +2348 4 48.8882 19.6696 33.032 -5.7885 3.32597 15.4548 +2349 6 29.6797 28.4194 31.2347 -18.17 -6.54897 12.3532 +2350 4 30.6054 28.3362 30.9452 0.112823 -13.8933 8.50124 +2351 4 29.3632 27.6339 31.7874 27.6893 19.0339 -22.4607 +2352 6 5.1089 39.1304 23.5821 16.3589 -26.7425 38.52 +2353 4 5.38369 38.72 24.4786 -14.1195 25.2427 -41.8592 +2354 4 5.12138 40.0884 23.679 1.29424 5.88982 9.05127 +2355 6 42.9406 13.5828 41.5963 2.4548 -20.3274 5.45752 +2356 4 42.752 14.3543 41.1051 4.71299 30.6973 -25.311 +2357 4 42.1302 13.4831 0.159852 -12.9765 -12.2431 17.3873 +2358 6 21.226 12.4267 7.36435 31.2446 -3.521 -2.03074 +2359 4 20.2961 12.4647 7.18572 -19.4619 -2.59914 -12.879 +2360 4 21.5838 11.6146 6.96487 -5.92297 6.31526 1.33966 +2361 6 43.1402 26.8798 37.6925 36.8226 -18.0871 25.2922 +2362 4 42.3701 26.4861 37.2457 1.92095 -10.9538 3.42147 +2363 4 43.8051 26.2366 38.1772 -44.9135 25.1765 -29.4158 +2364 6 19.5374 10.6589 41.6895 -5.57828 -38.0023 -10.1688 +2365 4 19.1336 10.6448 0.637369 -6.5477 2.89313 17.0607 +2366 4 19.8005 11.5407 41.5226 10.6711 39.664 -4.3781 +2367 6 53.6211 10.0725 3.2523 6.57913 5.47914 -9.18923 +2368 4 54.2317 10.83 3.34927 -4.54537 -9.93589 0.0420736 +2369 4 54.0384 9.44833 2.62164 -2.29754 8.8252 9.03809 +2370 6 17.5636 20.1992 28.4305 -16.5699 17.1528 15.5915 +2371 4 18.0548 19.7019 27.7957 9.40873 -10.9714 -15.8242 +2372 4 18.1497 20.2955 29.1876 1.50874 1.07066 2.83373 +2373 6 36.8673 7.33814 1.69171 -42.7001 9.70605 -8.47937 +2374 4 37.6788 7.60022 2.09727 18.2611 10.2246 9.26811 +2375 4 36.4242 8.16776 1.39628 11.5951 -12.345 5.16871 +2376 6 29.225 41.4226 1.83075 -19.1389 21.107 -1.05665 +2377 4 28.4254 0.0289368 2.09685 16.3458 -11.1471 3.47601 +2378 4 29.1672 41.4088 0.871311 7.531 -2.47214 -5.14574 +2379 6 13.5148 3.09025 8.11784 -10.8355 13.5741 -3.86075 +2380 4 12.8447 3.80664 8.08285 8.27234 -10.6709 -2.48032 +2381 4 13.8247 3.09872 9.02804 1.30446 -5.60755 1.07776 +2382 6 15.035 29.5824 18.5052 -13.3664 3.09019 -9.07378 +2383 4 14.628 28.8743 17.9722 6.78876 3.62049 6.93265 +2384 4 14.2975 30.1967 18.6986 12.8362 -2.82157 -1.1162 +2385 6 10.5118 24.7077 24.3903 18.3301 23.9761 -31.3173 +2386 4 10.707 24.7057 23.4146 -4.2845 7.89501 28.372 +2387 4 10.0612 23.8909 24.4849 -17.9274 -27.8 13.6507 +2388 6 2.3293 13.8562 25.1542 8.14415 -2.44132 2.05706 +2389 4 1.63302 13.4321 24.6436 -3.32338 -7.08116 -5.4939 +2390 4 2.0923 14.7815 25.112 -7.52471 9.11743 -0.122921 +2391 6 31.8571 32.759 29.7983 3.65167 10.3578 -8.56752 +2392 4 30.9277 32.9381 29.9784 -0.622435 -3.80813 0.732423 +2393 4 31.8884 31.8723 29.4276 -3.71181 -5.10697 -2.58235 +2394 6 37.531 40.8209 33.967 -23.153 -16.1875 5.3836 +2395 4 37.3251 40.1347 34.6985 0.870468 26.6491 -35.3147 +2396 4 36.773 40.8784 33.3102 18.3716 -9.25033 25.8989 +2397 6 24.0485 38.1313 34.3431 -11.5105 1.837 -35.773 +2398 4 24.1907 38.198 35.2802 9.24451 -7.73664 19.5979 +2399 4 24.4675 37.3552 33.934 1.62169 3.10325 14.1331 +2400 6 37.1852 22.5711 7.36841 5.54302 -17.8805 15.7599 +2401 4 37.6193 21.7136 7.5635 -9.24307 15.2983 -3.07678 +2402 4 37.2973 22.7156 6.43503 3.10694 -1.55352 -15.3513 +2403 6 4.30637 23.241 35.6005 -21.8515 -3.12039 0.833232 +2404 4 4.28153 22.3978 35.1252 -1.17938 4.50836 1.52069 +2405 4 3.36633 23.5034 35.7569 13.5984 -2.36814 -1.35472 +2406 6 15.7372 14.8984 2.68389 5.83394 8.18523 30.6602 +2407 4 16.0581 15.8209 2.80401 -5.66096 -17.7803 -6.78984 +2408 4 15.4195 14.7671 1.79524 0.865375 8.28049 -11.4308 +2409 6 48.1667 23.1873 2.04358 2.14857 -5.2771 -14.5053 +2410 4 48.6748 23.4267 2.82287 11.4848 0.866046 3.26637 +2411 4 48.7964 22.9219 1.32588 -13.3162 5.875 14.6145 +2412 6 24.1221 19.9752 21.5371 -32.3717 23.6383 6.86593 +2413 4 24.143 19.3917 22.3107 11.6246 -2.80692 -10.3828 +2414 4 24.7866 19.7762 20.8968 22.5091 -14.1667 -7.68302 +2415 6 10.5822 29.3968 5.14403 -6.21678 -11.6361 15.7318 +2416 4 9.83188 29.7897 4.67624 10.1791 9.93667 -6.35089 +2417 4 11.4324 29.7717 4.90568 -2.60747 8.99296 -10.7541 +2418 6 5.96985 27.6957 31.2251 14.0826 -21.4471 -14.909 +2419 4 6.62108 27.1001 30.7651 -15.2176 13.0885 7.83628 +2420 4 6.49554 28.1541 31.8886 3.5811 4.10899 4.91189 +2421 6 18.524 25.7945 15.3346 -6.80319 -1.26411 -41.3947 +2422 4 18.3129 25.8537 16.2191 -1.03447 -6.47723 71.4836 +2423 4 17.8509 26.3975 15.0287 -5.96066 9.61194 -22.438 +2424 6 52.0911 37.2147 11.1191 10.7944 -12.7592 -3.2574 +2425 4 52.6735 36.5031 10.7991 -6.06835 6.24709 5.19982 +2426 4 52.6754 37.9802 11.2539 -6.64808 -1.57102 -0.449092 +2427 6 46.8545 14.6154 7.32174 -10.4102 9.08531 6.17155 +2428 4 46.1761 15.2305 7.76384 29.9054 -34.6086 -7.32766 +2429 4 47.196 13.9114 7.91569 -13.0839 18.0399 0.731203 +2430 6 22.2426 0.701706 41.6733 41.1626 12.534 -29.9538 +2431 4 22.236 1.66756 41.6378 -9.79705 -6.68715 4.90956 +2432 4 23.0808 0.492341 41.1545 -29.2322 -0.545859 23.5967 +2433 6 4.06645 14.7285 9.26505 -5.79968 22.7562 -12.5209 +2434 4 3.53709 15.5501 9.07402 9.13976 -21.8289 3.48331 +2435 4 4.94549 14.9564 8.94351 2.1847 -1.50717 0.750146 +2436 6 37.293 12.6643 37.0348 -15.3153 -6.18171 16.0178 +2437 4 37.7524 12.8164 37.9019 -17.8573 -2.14895 -9.99561 +2438 4 36.3666 12.3049 37.1727 33.7628 8.85249 1.83374 +2439 6 26.6624 29.0693 40.5955 -26.637 27.4899 13.7151 +2440 4 27.0962 28.2693 40.8235 19.1059 -29.7051 -2.9078 +2441 4 26.7436 29.2635 39.6647 9.93266 -1.33043 -11.4317 +2442 6 7.23743 13.8563 3.32048 -33.1041 -30.3754 -14.41 +2443 4 7.96064 14.4301 3.56742 25.5688 -7.52041 0.820923 +2444 4 7.42976 12.8854 3.09984 6.81051 43.2082 15.4509 +2445 6 8.94797 34.8532 28.8254 23.4184 -23.2786 -12.4265 +2446 4 9.89546 35.0323 28.6727 -12.7097 -5.00209 3.03018 +2447 4 8.59604 35.6886 29.0779 -14.3686 23.8739 12.2374 +2448 6 37.2014 40.0808 40.1141 12.7521 0.43192 13.6168 +2449 4 36.2619 40.0837 39.9632 -10.4254 2.72875 -6.67898 +2450 4 37.248 39.4512 40.8496 7.71934 0.19736 -2.65382 +2451 6 30.3728 6.17428 27.2502 2.34222 12.9127 24.6773 +2452 4 30.0491 5.75377 28.1093 17.5599 21.8776 -23.7977 +2453 4 31.0277 6.90628 27.4549 -18.5498 -22.5685 3.02853 +2454 6 10.4851 22.8816 18.2947 -6.39025 -14.7202 -25.3901 +2455 4 11.3539 23.0451 18.66 8.78619 -1.44678 0.615593 +2456 4 10.601 22.3432 17.4702 -0.435219 15.7289 22.4338 +2457 6 35.9047 14.2516 40.1476 -11.9566 8.08227 -8.12446 +2458 4 35.3828 14.5983 39.4171 17.9635 11.5828 -3.36223 +2459 4 35.2535 13.6726 40.504 -8.36759 -16.975 21.7169 +2460 6 6.70775 1.0715 17.7189 7.50642 -21.2746 -7.36561 +2461 4 6.22784 1.34485 18.5084 1.44497 -10.5234 3.95628 +2462 4 6.91772 0.0894674 17.7256 -13.4419 30.1572 13.7277 +2463 6 41.3365 34.0623 33.1636 23.1157 -5.84267 13.8333 +2464 4 40.4227 34.234 32.9444 -15.3258 11.3352 -14.6542 +2465 4 41.9184 34.5849 32.5841 -12.4833 3.91505 -3.84565 +2466 6 37.2858 0.99342 41.2878 7.36827 13.3221 -16.8172 +2467 4 37.4859 0.112276 40.9658 -1.88555 -12.2628 0.361589 +2468 4 37.4834 1.0172 0.312287 5.29267 -3.40266 15.6364 +2469 6 25.2541 30.9749 6.2071 -22.7336 2.5299 17.3506 +2470 4 26.0217 31.2424 5.69829 1.89843 -3.96463 -15.2281 +2471 4 24.4182 30.8551 5.69564 23.045 5.74277 3.20871 +2472 6 14.1871 24.4929 28.313 -6.35756 40.4048 -1.58139 +2473 4 14.3311 23.6816 28.7714 -3.10946 -31.1704 -0.0360927 +2474 4 13.792 24.4319 27.4273 2.40698 -14.1025 6.50138 +2475 6 34.2078 26.2332 36.0169 -41.3887 31.6455 20.302 +2476 4 35.1375 26.2713 36.1926 18.3831 1.21525 6.50399 +2477 4 33.7458 26.9646 36.5669 26.0782 -29.6148 -21.0343 +2478 6 32.3696 8.32545 27.9988 -31.7689 14.924 14.5852 +2479 4 32.5206 9.30939 28.0669 10.5891 -30.1429 -9.37737 +2480 4 33.1235 7.86931 27.6333 20.3768 10.5357 -6.59273 +2481 6 11.7881 0.276326 26.9686 -1.26514 -24.1343 -2.09554 +2482 4 11.7898 41.2288 26.6922 -1.19404 21.3361 9.01519 +2483 4 11.5977 0.31005 27.9205 2.09711 -1.6438 -10.9729 +2484 6 1.68282 0.256654 10.3371 7.78574 -7.1909 -12.7427 +2485 4 1.59984 41.2742 10.69 -0.913761 -2.35777 -0.20094 +2486 4 1.41183 0.821253 11.0453 -5.61238 10.3042 16.839 +2487 6 6.75659 13.8554 8.24275 2.15336 8.75665 -12.4729 +2488 4 6.4538 13.9004 7.29654 11.603 6.79512 25.9161 +2489 4 7.29723 14.6482 8.44053 -3.39366 -6.31817 -8.96948 +2490 6 22.229 20.5516 6.16712 -19.4021 -6.23502 11.2792 +2491 4 21.7175 21.3783 6.29668 6.22315 -10.0472 -0.391558 +2492 4 21.7004 19.8262 6.58709 9.33903 15.1246 -7.94106 +2493 6 17.3809 20.4508 10.8712 -6.33142 3.08518 -4.04876 +2494 4 16.5461 20.08 10.4568 21.8919 23.129 5.85777 +2495 4 17.5363 21.4129 10.6625 -13.97 -26.3983 1.7074 +2496 6 17.7006 4.52466 19.5892 5.66371 -4.97651 -9.86024 +2497 4 16.9376 4.52739 20.1892 -4.06273 -5.34645 -7.80596 +2498 4 17.5412 3.84457 18.8839 -0.885651 16.9891 23.3258 +2499 6 0.475545 18.1168 40.0844 5.30586 -7.45209 -16.0452 +2500 4 0.255658 18.7395 40.7612 -0.602959 14.3131 10.4938 +2501 4 1.33302 18.3868 39.7002 -7.70736 -6.31105 3.74686 +2502 6 22.9439 24.8338 27.8349 -3.23408 23.09 -51.7359 +2503 4 22.7283 25.5292 27.1178 5.97449 -27.0764 31.3639 +2504 4 22.8278 25.2464 28.677 -4.11703 14.8593 21.0934 +2505 6 42.7959 39.1553 26.7627 -13.6288 14.9904 24.3142 +2506 4 42.9559 38.4383 26.1586 10.7263 -7.78522 -15.113 +2507 4 43.351 39.9224 26.5692 3.77188 -7.24305 -5.18193 +2508 6 26.2354 3.05796 21.7982 1.74018 25.1467 -10.7915 +2509 4 25.6923 3.78105 22.1642 10.9011 -13.8467 -3.1836 +2510 4 26.7888 3.50003 21.1142 -10.0122 -11.5362 10.4851 +2511 6 54.6007 9.88011 29.5829 2.61324 -0.835643 16.9334 +2512 4 53.983 9.1383 29.6239 1.49377 0.577448 -2.59463 +2513 4 54.746 10.0983 30.5296 -2.21833 -1.79811 -18.9561 +2514 6 24.7578 33.7363 20.5387 -17.5006 5.04967 -0.0763559 +2515 4 24.6934 34.6555 20.8512 7.60819 -4.12262 3.6003 +2516 4 23.9235 33.6132 20.0554 5.3121 -3.42637 -1.44671 +2517 6 41.6963 16.3109 0.897802 2.88421 10.066 -28.0255 +2518 4 41.3077 16.0362 1.70176 -16.3219 -5.78099 30.2108 +2519 4 42.6299 16.1901 1.06805 12.6035 -3.11322 -2.97519 +2520 6 23.404 27.9303 27.4821 -1.06023 20.2241 -21.3645 +2521 4 22.8141 28.2554 28.1835 2.551 -1.87769 -8.73241 +2522 4 23.2629 28.4828 26.6516 2.17993 -16.4871 31.3925 +2523 6 32.7813 37.2936 18.7328 38.5641 -14.7697 6.75932 +2524 4 33.752 37.1016 18.9061 -34.9795 -0.437252 0.892363 +2525 4 32.8311 38.1729 18.3762 -6.70298 14.6722 -8.07554 +2526 6 21.2305 27.6771 4.7955 -18.4608 -25.795 -24.9287 +2527 4 20.5062 27.4644 5.39651 2.92048 5.31567 1.45057 +2528 4 20.941 27.2184 3.94502 12.5509 18.4099 23.8236 +2529 6 54.9409 17.9571 1.83459 -7.07205 6.42915 6.55936 +2530 4 54.7029 17.1381 1.42965 7.06691 -21.815 -7.49321 +2531 4 54.119 18.4405 1.74821 -9.38537 8.8513 -0.363257 +2532 6 36.7335 10.6984 6.58912 -34.5362 -0.324761 -4.53473 +2533 4 35.7609 10.9799 6.6143 34.1258 -12.1011 2.72213 +2534 4 36.7696 9.77633 6.90859 -3.13742 6.31851 -1.30765 +2535 6 54.2706 4.50024 14.0257 -11.269 5.99606 -15.4247 +2536 4 53.8536 5.11876 13.3604 4.87759 -11.992 26.1673 +2537 4 53.895 4.59469 14.9192 -3.76531 8.72829 -7.53187 +2538 6 22.107 12.8255 32.0148 27.0088 -6.82073 4.3703 +2539 4 21.2061 13.1328 31.8952 -10.7145 6.62508 -9.34344 +2540 4 22.7298 13.2576 31.3917 -17.4011 -3.99159 8.00208 +2541 6 15.2931 36.6619 4.04206 -24.4039 12.3238 20.1693 +2542 4 15.3606 37.6342 3.9855 6.08423 -9.62309 -2.22716 +2543 4 16.0243 36.2999 3.55051 12.1414 -1.28609 -8.9598 +2544 6 23.9518 1.27347 5.70825 1.82336 16.8815 15.3992 +2545 4 23.158 0.731739 5.71694 -5.31944 -7.03749 -3.2154 +2546 4 23.9846 1.73289 6.57368 -1.26671 -8.46254 -14.2674 +2547 6 14.3069 12.6571 15.8074 -11.3886 -13.8779 -22.9988 +2548 4 14.4908 12.4438 14.8835 17.1875 4.58775 1.43504 +2549 4 13.3991 12.3171 15.8566 5.60683 8.95198 18.2444 +2550 6 15.0463 40.2277 6.58272 -14.4539 15.1029 5.15073 +2551 4 15.8086 40.489 7.08192 22.3652 -6.01515 7.9389 +2552 4 14.4962 41.022 6.75392 -6.77819 -16.9793 -13.6053 +2553 6 48.5629 32.6194 12.091 2.37027 -5.84764 -3.4739 +2554 4 48.1048 31.8776 11.6348 7.57669 12.4587 1.43975 +2555 4 49.3373 32.9111 11.5511 -18.0393 -12.2542 5.39731 +2556 6 11.2883 31.5349 7.21941 -5.75599 -10.1169 -16.3625 +2557 4 10.675 30.8987 6.79271 12.7122 10.5617 8.56414 +2558 4 11.681 32.0415 6.48473 -4.52974 -6.63428 7.17241 +2559 6 30.1204 27.9925 10.216 2.65146 5.67665 0.571004 +2560 4 30.7332 28.7325 10.019 -7.63861 -11.6097 -0.594568 +2561 4 29.9063 27.5181 9.39417 2.857 4.22172 -1.33476 +2562 6 27.6817 22.1076 17.3717 2.13561 -8.21554 7.46684 +2563 4 27.3138 21.4721 16.7296 5.88092 9.15558 -3.1228 +2564 4 28.0594 22.8778 16.9197 -3.27829 -5.84867 -5.86393 +2565 6 12.9588 4.5965 18.1625 2.45174 -26.8216 -12.137 +2566 4 13.4346 3.75914 18.3684 -5.38503 16.4797 0.486183 +2567 4 12.5704 4.4145 17.2814 1.35975 11.1796 8.84538 +2568 6 19.7171 6.72206 19.0824 18.7149 18.1076 8.78634 +2569 4 19.0276 6.07043 19.1643 -12.8479 -14.7766 2.48779 +2570 4 20.149 6.78349 19.9504 -8.03044 -1.70313 -8.42964 +2571 6 37.158 31.386 11.4948 13.5333 -6.17925 -0.534196 +2572 4 36.3748 31.5241 12.0574 10.6691 -10.2998 8.4252 +2573 4 37.8298 30.7884 11.9154 -26.2348 9.80485 0.777976 +2574 6 3.12167 16.2038 27.3537 -19.2499 -26.3416 -14.9115 +2575 4 2.564 15.4232 27.613 17.9651 21.4634 -3.17821 +2576 4 3.05771 16.2343 26.3741 -0.0558506 5.44355 20.7735 +2577 6 15.7152 9.97508 38.3617 37.2659 20.4939 22.6587 +2578 4 16.1689 10.8384 38.1525 -17.0523 -25.976 5.55091 +2579 4 16.2475 9.64647 39.1327 -18.0975 2.21635 -20.7757 +2580 6 13.3945 14.2914 8.22355 52.7406 24.0557 20.8129 +2581 4 13.9343 15.0997 8.53617 -32.8018 -27.7376 -11.9171 +2582 4 14.0669 13.5802 8.35008 -24.0553 1.67412 -6.96019 +2583 6 1.72299 24.3133 36.3936 32.5837 -28.3335 21.1288 +2584 4 1.96116 25.1215 36.8464 -1.44419 12.4956 -1.11134 +2585 4 1.10799 24.5417 35.7277 -24.491 15.1488 -24.3141 +2586 6 11.1925 26.5189 32.9725 1.88857 3.23229 20.5962 +2587 4 10.9062 26.8258 32.1286 -6.138 -2.28585 -27.1412 +2588 4 11.0637 27.2989 33.5293 3.02186 -7.15206 7.83107 +2589 6 29.5898 0.769141 36.29 0.770047 10.6645 18.3277 +2590 4 29.1085 0.54227 35.5145 -3.81283 -13.529 -27.0487 +2591 4 28.8904 1.11515 36.8518 6.86702 4.29265 4.12775 +2592 6 43.6054 13.1224 23.9122 -2.46968 6.93561 -17.1322 +2593 4 42.8447 13.3401 24.4619 -4.47847 1.10283 0.728731 +2594 4 43.3126 13.2067 22.9653 4.50753 -0.208477 27.3689 +2595 6 7.45217 19.7807 19.6677 5.33955 -1.6221 -12.877 +2596 4 6.80427 19.1226 19.9251 -3.45906 -4.13396 8.35684 +2597 4 7.46466 19.745 18.7046 0.226191 5.91599 3.73904 +2598 6 24.4186 4.28854 7.83154 -9.27237 -3.93777 -5.86373 +2599 4 24.1141 5.19611 7.95791 2.72117 -5.11917 -0.666563 +2600 4 25.0574 4.07609 8.5187 1.73531 2.38301 -0.0162684 +2601 6 51.4783 30.2365 31.1578 4.43663 8.1051 17.8753 +2602 4 50.5719 29.9409 31.3316 -1.01079 -0.531629 -9.26743 +2603 4 51.6665 30.2531 30.2149 -6.58635 -1.64064 -12.0931 +2604 6 0.928618 23.6677 16.8891 39.1558 -2.20072 16.2176 +2605 4 0.0728448 23.4362 16.5368 -6.93512 -13.3273 -6.91209 +2606 4 1.45563 22.867 17.1505 -20.9828 13.2836 -9.64814 +2607 6 45.0876 19.3948 15.692 7.86589 27.8079 -34.4593 +2608 4 45.9117 18.9264 15.546 6.38244 -8.87865 2.87525 +2609 4 44.6429 18.9609 16.3882 -19.7965 -22.2098 30.8606 +2610 6 17.4975 8.71947 40.5884 -15.3884 33.6574 -8.04213 +2611 4 18.1832 9.38307 40.741 -0.0730079 1.31818 -0.306908 +2612 4 17.9142 7.90906 40.8182 15.4372 -26.466 6.58932 +2613 6 30.1853 27.2566 27.195 -12.9952 17.3445 1.1523 +2614 4 31.1231 27.467 27.0889 -0.851996 0.391463 0.93648 +2615 4 29.6983 28.1205 27.2412 18.1484 -22.709 -4.59112 +2616 6 43.0643 26.2027 28.3545 -5.31946 22.0639 -20.7107 +2617 4 43.281 25.753 27.5201 1.76973 -3.45008 6.18356 +2618 4 43.0898 25.5645 29.0616 2.35339 -12.574 6.70826 +2619 6 27.9963 7.58777 3.05558 10.5798 9.34284 19.8534 +2620 4 28.0446 6.83168 2.47717 -2.58104 -14.3156 -10.0889 +2621 4 28.509 7.35692 3.86128 -6.64638 2.01122 -8.68086 +2622 6 44.6822 7.22369 10.1895 -15.4824 21.4485 13.7445 +2623 4 44.4465 7.45383 11.1264 7.27839 -9.51736 -18.1425 +2624 4 45.2115 6.42757 10.2073 4.94307 -7.89984 8.76143 +2625 6 23.5336 20.3897 32.2571 -4.86538 -1.36788 -16.1605 +2626 4 23.3032 21.2113 32.7104 1.28111 0.523216 5.34569 +2627 4 23.9774 19.8232 32.8948 2.81274 0.218846 6.19737 +2628 6 37.5478 21.0473 29.278 -18.5062 7.79735 6.57819 +2629 4 37.2371 20.358 28.6908 4.72073 -14.165 -12.1471 +2630 4 36.7158 21.4163 29.628 13.2175 4.90017 2.66375 +2631 6 49.286 29.0703 28.699 10.8186 8.22027 -9.31733 +2632 4 48.7028 29.7991 28.456 -10.3299 -0.414367 -0.610456 +2633 4 50.1517 29.4276 28.433 0.637469 -9.81751 4.99071 +2634 6 47.52 18.1671 15.2208 -2.7229 30.7912 -34.1138 +2635 4 48.0078 17.7317 15.8928 12.2019 -13.0526 25.5862 +2636 4 48.0044 19.0008 15.0204 -10.6208 -16.322 3.06818 +2637 6 23.2448 11.1727 16.5931 -14.8157 -11.6244 -0.308602 +2638 4 23.8342 11.8286 16.2582 11.4387 21.3683 -6.30591 +2639 4 23.6559 10.3501 16.3116 -3.14365 -5.23997 2.15847 +2640 6 3.13911 8.33446 23.1963 -2.69702 8.14317 3.16076 +2641 4 3.4034 7.82956 22.4196 3.11719 -1.75335 -2.44085 +2642 4 3.61355 9.18537 23.1574 -2.855 -3.87959 1.25156 +2643 6 0.502965 16.1866 6.18545 3.06312 3.24934 37.7622 +2644 4 1.47856 16.2897 6.04903 -24.0003 -4.70784 4.68468 +2645 4 0.309706 16.1237 7.18858 13.4295 2.89967 -42.1744 +2646 6 43.1771 15.7066 5.83749 -5.07319 -7.51407 -5.60477 +2647 4 43.0136 16.4204 6.43488 -7.5966 11.2789 14.4199 +2648 4 44.0623 15.8898 5.5251 15.5631 0.134699 -7.60204 +2649 6 16.7019 35.4798 34.4572 -11.2013 7.16284 28.6023 +2650 4 15.9782 34.9492 34.0738 5.35466 1.61493 8.45244 +2651 4 16.3895 35.7941 35.362 6.52255 -9.83405 -29.4813 +2652 6 38.8822 7.74245 15.6771 24.467 26.2162 11.5837 +2653 4 39.1941 7.06316 15.0707 0.325231 -3.95447 -5.25413 +2654 4 39.6937 8.2709 15.9758 -30.2905 -22.5291 -12.0432 +2655 6 42.0043 36.5204 13.6369 3.57579 19.2035 0.0265624 +2656 4 41.9371 35.5667 13.6578 -6.58441 -9.91584 1.38486 +2657 4 41.1548 36.8737 13.3269 0.670997 -7.61264 0.497391 +2658 6 54.2965 15.3698 32.1203 7.94984 -1.57724 11.6593 +2659 4 0.00278476 15.9714 32.4364 -1.97539 -6.90512 -0.0853595 +2660 4 53.6257 15.9484 31.7567 -4.83125 0.736868 -4.95397 +2661 6 22.8953 13.994 39.0277 29.317 0.766946 3.70607 +2662 4 23.2673 14.8115 39.3939 -3.87119 -6.48985 -1.20924 +2663 4 21.9724 14.1463 38.894 -27.0425 2.87882 -4.26486 +2664 6 48.0413 28.5291 4.79053 -11.6037 -2.58599 22.6989 +2665 4 48.6027 28.7991 4.07655 16.555 3.34212 -19.6439 +2666 4 47.7045 29.3636 5.15455 0.064426 -0.719185 3.47056 +2667 6 48.8324 10.6079 2.66689 -4.06073 -3.45613 -38.269 +2668 4 48.225 10.1372 3.21562 -13.339 -11.2438 14.6703 +2669 4 49.3888 11.1314 3.20945 16.7197 17.33 23.918 +2670 6 17.1017 29.3417 4.42129 -6.1746 1.2215 19.6287 +2671 4 16.2515 28.9749 4.73431 4.06151 0.983408 -5.41825 +2672 4 17.5169 29.7258 5.22535 1.37581 -6.66399 -13.2687 +2673 6 27.7925 7.31966 26.5665 39.3465 35.5797 -5.30427 +2674 4 28.7629 7.09708 26.703 -34.5848 -6.71948 -0.628584 +2675 4 27.2286 6.57009 26.6643 -1.86949 -31.2701 4.24572 +2676 6 18.0221 22.0409 22.5172 -16.5701 10.2349 -21.3339 +2677 4 18.5639 21.2383 22.5163 -1.8186 -3.43948 -8.36361 +2678 4 17.5144 22.1102 21.6408 22.068 -10.0871 32.2991 +2679 6 22.1395 25.0891 16.7042 -20.9036 23.9116 7.05274 +2680 4 21.7854 25.6501 15.9625 11.5166 -19.4533 18.3362 +2681 4 22.5191 24.3092 16.3181 5.92374 -8.20656 -11.3677 +2682 6 25.488 28.4523 7.12785 -10.8823 -15.9396 20.8595 +2683 4 25.4981 28.5494 8.12476 3.48758 8.16016 -33.1398 +2684 4 25.5521 29.3092 6.69674 -1.4246 11.8198 7.49476 +2685 6 42.5416 24.7341 23.7389 -17.4504 20.5814 2.46415 +2686 4 41.7374 25.1978 24.1118 21.637 -12.0739 -8.95046 +2687 4 42.3838 23.7928 23.8344 -7.43983 -12.597 1.84916 +2688 6 6.22002 16.6178 2.47863 15.1987 22.5956 5.3052 +2689 4 5.33799 17.0017 2.41879 -13.1624 -14.3434 -0.0608379 +2690 4 6.24934 15.6649 2.55192 -10.5885 -12.312 -0.729605 +2691 6 47.3735 33.281 1.45237 -1.26376 -9.34891 -34.4477 +2692 4 47.004 34.1558 1.53803 -0.151384 8.42018 6.19826 +2693 4 47.7374 33.0316 2.29181 5.29029 2.56444 17.845 +2694 6 1.28124 36.1882 24.8833 15.6174 10.404 -23.7919 +2695 4 0.591937 36.4933 25.4703 -7.67557 -4.15788 11.0948 +2696 4 1.63511 35.375 25.2549 -3.92235 -3.89482 10.8998 +2697 6 20.9296 29.0485 16.4244 -14.8946 8.72798 0.140185 +2698 4 21.4494 28.4837 15.8729 6.14594 -21.5718 -11.6475 +2699 4 21.5122 29.7657 16.643 5.64358 11.2813 6.66084 +2700 6 18.6504 32.5428 14.1464 30.5599 1.70581 -2.73789 +2701 4 17.8579 33.056 14.2705 -20.3424 -4.20043 8.80032 +2702 4 18.5989 31.5954 14.3835 -16.0449 10.8642 1.76069 +2703 6 15.729 41.6925 0.00385817 -5.28292 -15.868 -0.0471225 +2704 4 15.6317 41.084 41.1283 -1.722 11.921 23.9575 +2705 4 15.1873 41.3899 0.782005 8.67232 1.52126 -23.9336 +2706 6 20.5292 18.4098 7.21323 -2.91221 4.89049 5.17577 +2707 4 20.2914 18.5583 8.16487 -5.028 -0.721877 -18.2737 +2708 4 19.7413 18.3526 6.62958 8.30767 0.291632 18.8261 +2709 6 35.3342 2.82915 1.61883 3.51298 26.3767 19.1091 +2710 4 35.0331 3.19583 2.50754 16.3791 -7.36031 -35.2043 +2711 4 35.9206 3.53855 1.22039 -16.4006 -18.5858 14.5973 +2712 6 48.9922 19.6721 24.94 -34.075 0.0390245 -1.22883 +2713 4 49.8199 19.2352 24.7823 16.5976 -0.114011 -0.96393 +2714 4 49.1617 20.6125 25.0649 5.94448 -3.86752 4.03728 +2715 6 26.0294 7.18427 41.5679 18.6543 -22.0446 -14.9111 +2716 4 26.7755 6.56315 41.735 -11.6555 11.6244 -4.08136 +2717 4 25.6575 7.3193 0.515359 -11.3234 5.2253 22.1616 +2718 6 22.0232 3.61039 29.0191 -5.74486 -2.38085 -7.46091 +2719 4 21.2539 3.82496 28.4513 11.98 3.27859 6.66273 +2720 4 22.2148 4.35673 29.5966 -4.60401 3.08527 0.791206 +2721 6 27.8512 32.5337 20.6565 16.709 -10.0789 14.6393 +2722 4 26.9625 32.7469 20.4552 -34.4793 1.21347 -3.16249 +2723 4 28.3469 33.1233 20.1026 12.1012 5.18966 -5.24336 +2724 6 8.41229 24.7869 3.46082 22.3386 15.1563 9.53263 +2725 4 8.90357 24.2552 2.84068 9.55631 -8.44952 -10.853 +2726 4 7.60423 24.3318 3.61908 -22.8615 -12.1417 2.22131 +2727 6 30.5897 41.7312 15.6484 22.6974 7.2585 28.5546 +2728 4 29.9644 0.0840213 16.3484 1.9076 -3.76769 -8.41354 +2729 4 30.1014 41.5664 14.8669 -20.7398 -7.21626 -25.2002 +2730 6 48.088 5.62638 21.1953 6.60529 -8.20232 0.106871 +2731 4 47.6746 6.34733 20.7055 -8.23977 -5.05625 1.96425 +2732 4 47.4017 5.06013 21.5879 -0.150274 10.975 -6.21391 +2733 6 39.4216 23.1741 35.7526 -24.6601 -13.9913 -21.1364 +2734 4 39.9113 23.6202 36.3986 28.8985 24.9348 33.8823 +2735 4 38.8958 22.5444 36.2533 -4.57276 -5.65639 2.90172 +2736 6 51.5794 33.3637 5.78804 -15.2387 -43.0642 -16.4958 +2737 4 51.7543 34.264 5.94613 8.32006 43.2545 8.99501 +2738 4 51.5314 33.243 4.82206 1.27667 3.09716 8.04215 +2739 6 40.1245 17.6149 30.7901 8.56984 -3.86721 -1.09973 +2740 4 39.7659 18.4612 31.0527 -2.58034 0.199434 5.42908 +2741 4 40.7245 17.8709 30.0792 -0.880063 -10.8459 -3.09375 +2742 6 46.409 9.80599 18.5787 -10.6525 10.5445 16.3312 +2743 4 47.1858 10.3579 18.4839 1.73901 1.20814 1.97642 +2744 4 46.4156 9.2339 17.8265 -1.18405 -17.3223 -19.0152 +2745 6 15.8964 41.084 31.9275 -7.67529 -16.3413 6.36199 +2746 4 16.5726 40.6297 31.3851 0.744388 15.1086 2.48527 +2747 4 16.0838 0.121849 31.9545 10.6182 0.477469 -6.79561 +2748 6 48.5579 25.7373 14.9245 -32.9201 0.62376 14.4593 +2749 4 49.4842 25.8337 14.7718 19.5896 2.21134 -17.0603 +2750 4 48.049 25.8802 14.1037 15.4245 2.93063 1.46628 +2751 6 39.2312 28.9787 36.1455 -14.672 -4.00104 3.01304 +2752 4 39.9934 29.3216 36.628 6.25522 6.25199 -7.03146 +2753 4 39.4638 28.7366 35.2366 10.4577 0.0924929 -3.6403 +2754 6 37.3289 21.0516 14.9314 -10.8689 -7.09111 1.49701 +2755 4 38.071 20.892 14.3011 -28.0288 10.0477 -1.14031 +2756 4 36.4673 21.3942 14.5393 36.2132 -8.93414 7.14583 +2757 6 32.4934 22.8531 15.7417 3.10645 -11.4389 20.7178 +2758 4 31.7266 22.539 15.2235 4.17967 -1.79737 6.20971 +2759 4 32.6084 22.2825 16.5528 -7.19864 12.5613 -26.7488 +2760 6 18.5678 8.15053 37.5885 12.1963 17.253 1.38788 +2761 4 19.2402 8.85275 37.7813 -15.6951 -12.294 2.78452 +2762 4 17.9606 8.11124 38.3342 2.60008 5.05619 4.87993 +2763 6 46.9436 30.3797 11.0104 1.88703 -1.83756 -2.66296 +2764 4 46.4577 30.6986 10.2121 16.8565 -15.5671 12.8865 +2765 4 47.4104 29.5424 10.7815 -11.8828 15.01 -3.66074 +2766 6 54.6316 13.0448 30.6676 -4.47091 -6.8042 2.85617 +2767 4 54.8929 12.2323 31.1402 -1.2342 7.60269 0.15722 +2768 4 54.6603 13.771 31.309 -0.297949 0.849652 -1.52079 +2769 6 32.2951 35.1224 27.9786 -1.77947 21.9995 15.3623 +2770 4 32.2792 35.8643 28.662 -2.01418 -27.5067 -15.3374 +2771 4 32.1621 34.2527 28.3767 0.559318 -0.0892981 14.8897 +2772 6 4.45055 25.4036 31.7899 -1.02142 -16.2715 16.4968 +2773 4 4.99753 24.9958 32.4777 -6.33224 -6.47315 3.67169 +2774 4 4.91071 26.2154 31.6821 9.55032 31.2277 -12.9728 +2775 6 40.7771 38.1434 21.8579 6.80518 1.6634 -4.63259 +2776 4 40.7449 39.0581 22.1203 -10.5616 15.8809 15.9679 +2777 4 41.4448 38.2055 21.1733 6.63637 -13.627 -11.1518 +2778 6 26.6799 9.85647 27.3982 -25.6987 30.8747 18.2417 +2779 4 27.0738 9.12687 26.9584 7.64189 -30.2216 -11.3166 +2780 4 25.7862 9.62595 27.7363 13.5029 -2.01996 -6.34848 +2781 6 53.4177 39.431 11.7682 60.4327 6.90374 -14.3662 +2782 4 54.4363 39.4906 11.5459 -51.7213 -2.15349 13.0324 +2783 4 53.0514 40.2823 11.4531 3.65586 -10.6921 6.91198 +2784 6 35.3318 21.4177 2.24537 5.41769 -12.1321 -20.1082 +2785 4 34.8431 20.6225 2.51379 1.47903 7.83344 1.83382 +2786 4 35.7036 21.1864 1.3528 -11.9529 6.47568 24.5243 +2787 6 4.13637 17.136 33.9211 3.37621 -12.3766 5.67686 +2788 4 4.20441 16.396 34.5697 -7.88327 11.3141 -11.775 +2789 4 3.23668 17.1493 33.5445 4.32036 -6.23827 5.33579 +2790 6 24.1551 16.173 14.6595 0.905264 -13.203 -15.7913 +2791 4 24.2344 17.0724 14.9677 3.21898 8.1818 3.14137 +2792 4 23.7074 16.2777 13.8038 1.81958 -4.41422 2.08172 +2793 6 43.135 2.84466 26.1032 13.1229 6.35408 -5.68313 +2794 4 42.2875 3.17639 26.414 -4.49653 4.08553 -4.30298 +2795 4 43.2684 3.17059 25.1875 -5.24638 -3.17663 12.7173 +2796 6 40.6938 12.184 1.56501 -11.5288 -7.07153 -25.6549 +2797 4 41.6237 12.1687 1.8186 -0.151998 5.09311 17.9246 +2798 4 40.0653 12.4844 2.24465 11.7671 0.703669 4.7582 +2799 6 47.3771 8.09383 26.755 61.1653 27.2124 16.0462 +2800 4 46.6352 7.69428 26.3774 -33.8593 -24.2939 -29.8281 +2801 4 48.1554 8.02079 26.1437 -24.5213 -4.41693 14.2109 +2802 6 35.8722 30.7298 38.4929 46.7797 8.20249 -0.795626 +2803 4 35.8437 29.9971 39.0885 -23.8052 -20.0767 8.1402 +2804 4 36.8495 30.8926 38.5637 -31.083 11.8011 -18.5205 +2805 6 51.2951 23.2205 32.4921 -21.4102 17.5258 -2.96787 +2806 4 51.6315 24.0445 32.1105 -0.705735 5.94923 -0.836877 +2807 4 52.0737 22.714 32.6486 16.7198 -16.4886 4.04233 +2808 6 30.6141 4.4461 39.6711 -15.3731 3.79473 -35.0115 +2809 4 30.9464 3.61986 40.0176 9.77962 -4.83986 19.2734 +2810 4 30.7704 5.18568 40.2576 9.11216 5.26318 14.244 +2811 6 35.2646 29.7051 2.85778 -14.8887 -12.395 -20.7058 +2812 4 35.7986 29.7272 2.02588 -11.2321 -1.99949 14.2373 +2813 4 34.4405 29.1492 2.64359 32.9241 21.0754 6.44042 +2814 6 50.3111 26.1454 9.40098 -22.1621 10.9454 -20.0185 +2815 4 49.986 26.7793 8.71172 15.2241 -16.6208 13.1315 +2816 4 49.7063 25.388 9.31525 11.793 4.08785 3.97386 +2817 6 50.0869 36.8245 26.4088 -20.9012 -6.38176 7.71076 +2818 4 49.5586 36.0705 26.7514 3.9746 5.79943 -8.74909 +2819 4 50.1941 37.3864 27.1871 4.41306 8.36789 0.548966 +2820 6 40.3119 23.9565 38.5384 47.4279 -1.39254 -15.5521 +2821 4 40.88 24.732 38.748 -21.3925 -13.0784 -2.40019 +2822 4 39.4343 24.1145 38.8527 -20.1214 13.5622 11.7594 +2823 6 24.9444 10.7496 30.6663 31.051 18.5451 27.0394 +2824 4 25.7305 10.8456 31.2787 -28.4 -7.1047 -26.2292 +2825 4 24.8995 11.6269 30.2371 -7.15612 -14.1049 -2.61146 +2826 6 5.89131 1.01728 5.39947 -5.16247 -17.9253 -0.227043 +2827 4 5.22088 0.340863 5.59281 2.49468 7.88844 1.50452 +2828 4 6.71299 0.544267 5.57411 4.99832 4.76302 -4.28882 +2829 6 44.2927 29.3807 26.2764 43.728 -18.4205 -0.18667 +2830 4 43.5018 29.5461 25.816 -39.4067 7.83222 -12.62 +2831 4 44.7851 28.7616 25.699 -3.50466 6.32584 16.51 +2832 6 25.3064 10.1814 6.6654 -6.94402 -15.718 -9.61204 +2833 4 25.6542 11.0594 6.61048 6.10034 18.8978 1.37462 +2834 4 25.5624 9.77067 5.8255 0.943829 -2.29537 1.40094 +2835 6 13.3606 28.0664 2.58456 21.0736 -2.27515 1.79417 +2836 4 12.4645 27.8304 2.42125 -25.9451 -0.745297 2.44011 +2837 4 13.7867 27.7237 1.79619 10.8353 3.06046 3.23802 +2838 6 6.45257 40.24 18.0133 20.0379 8.33657 1.98834 +2839 4 6.89988 39.3931 17.8777 -5.14522 -3.62214 0.392952 +2840 4 5.56311 40.1207 17.6969 -15.0406 -3.82351 -6.06839 +2841 6 47.8011 13.5056 2.01844 -10.5648 -21.267 23.3214 +2842 4 48.1524 12.6081 2.17165 -2.87721 6.43796 -2.24674 +2843 4 48.4275 13.9546 1.48105 20.9852 11.6376 -18.273 +2844 6 13.5939 20.3067 2.43603 17.8956 14.689 14.157 +2845 4 13.8339 19.6256 3.09172 -4.40777 3.66463 -6.9739 +2846 4 12.9598 19.9059 1.86118 -14.8369 -10.3601 -11.305 +2847 6 15.2334 0.8368 36.6591 1.55142 7.70692 -22.3998 +2848 4 15.2542 1.38367 37.4773 0.960764 -3.32816 -20.1037 +2849 4 15.3344 1.45306 35.8608 -4.23652 -17.7771 37.8382 +2850 6 33.6147 35.2459 15.1 16.7734 -11.8793 -18.4599 +2851 4 33.8163 35.2873 16.0538 13.2499 -3.34836 -12.9991 +2852 4 34.4154 34.9808 14.5294 -23.6504 9.8312 34.8639 +2853 6 21.8005 9.23588 0.431159 13.8262 -19.7524 30.0596 +2854 4 22.4067 9.05801 41.6249 5.27322 -0.932182 -12.5411 +2855 4 21.1072 9.74412 0.0564903 -22.836 18.1195 -16.0408 +2856 6 38.1565 27.4627 3.04439 18.4183 -28.2807 7.84104 +2857 4 37.7322 27.3164 2.21113 -4.60599 -14.2952 -24.3043 +2858 4 37.7632 28.2451 3.34335 -13.6136 36.2365 19.5187 +2859 6 38.8873 27.196 11.7739 15.5044 -8.33717 -5.93911 +2860 4 38.7841 26.3327 12.232 6.37868 6.61944 -11.5261 +2861 4 39.5786 27.1133 11.0659 -17.5863 -8.28826 19.2684 +2862 6 29.8757 41.5959 28.7066 13.5858 28.49 -11.3766 +2863 4 28.9647 41.3014 28.7466 -9.40406 -2.02578 1.88502 +2864 4 29.8997 0.254331 27.9025 -2.68961 -11.7418 13.302 +2865 6 34.0266 8.72323 38.0698 33.719 9.40995 4.6971 +2866 4 34.8877 8.24089 38.094 -11.378 13.1352 -1.62724 +2867 4 33.3712 8.08689 37.8245 -20.4874 -15.945 -8.86187 +2868 6 38.8142 27.3472 30.6886 -7.48306 -22.0573 -0.58069 +2869 4 38.4096 26.5151 30.3537 9.19692 16.3236 1.53567 +2870 4 38.2655 27.5885 31.4334 -4.0026 6.56393 5.14207 +2871 6 41.6513 17.2644 36.3568 8.49285 18.5772 4.12306 +2872 4 41.236 17.1887 35.5016 -7.55839 -3.54967 -10.3568 +2873 4 41.7813 16.3888 36.7033 1.22956 -17.0266 1.65102 +2874 6 30.7157 26.9788 35.2038 -10.151 -4.28381 0.0670681 +2875 4 31.4488 27.4236 34.7965 20.0965 0.384289 -13.2747 +2876 4 30.343 27.6484 35.7639 -8.80839 6.96039 12.3672 +2877 6 47.5342 4.10778 27.2888 11.6095 8.93875 26.3727 +2878 4 46.6105 4.27591 27.501 -8.38331 -0.425724 -4.8003 +2879 4 47.5988 3.99389 26.3497 -6.2541 -0.220522 -17.1995 +2880 6 20.9412 8.38521 7.26575 -18.1268 -17.2637 2.68033 +2881 4 20.8809 8.87169 8.08328 -6.592 1.96128 21.9757 +2882 4 21.4179 8.98778 6.73029 19.5174 18.1449 -30.7672 +2883 6 36.8608 13.6781 0.872276 -22.567 18.0135 -7.8322 +2884 4 37.3857 13.5342 1.64823 18.2236 -14.2068 17.6988 +2885 4 36.9649 12.9376 0.269125 7.56106 -9.0363 2.17502 +2886 6 28.5805 20.3012 26.4498 13.4935 0.222411 -13.7489 +2887 4 28.4835 19.3803 26.2016 0.90122 -3.21423 2.30104 +2888 4 27.7964 20.5416 26.9224 -18.5183 5.12398 12.3317 +2889 6 51.6021 16.8515 33.5179 -11.2544 -15.3 0.627003 +2890 4 51.563 16.0241 34.0301 0.916298 4.09207 -0.753195 +2891 4 51.0058 16.6639 32.7753 6.31462 4.20327 -0.345536 +2892 6 16.2626 32.019 37.6812 -31.2107 -29.2496 -22.9287 +2893 4 16.4537 31.3803 38.4011 -2.23747 12.829 -12.3594 +2894 4 15.5373 31.5705 37.1079 31.9743 21.1891 23.5065 +2895 6 14.3366 25.8859 13.2055 -16.2598 35.1345 -7.65407 +2896 4 13.5591 26.1022 13.7538 4.79106 -9.45955 4.66587 +2897 4 14.3924 26.7004 12.6499 8.67511 -16.0651 4.90492 +2898 6 54.9632 28.863 3.30225 1.80665 -46.0259 4.02989 +2899 4 54.8334 28.8705 2.33571 2.30679 -1.29159 7.0988 +2900 4 0.250446 27.9134 3.53944 -11.9885 37.0888 -10.0107 +2901 6 17.2065 5.13222 2.58226 -24.5489 -19.7693 -14.9516 +2902 4 17.8239 4.45011 2.8785 5.4716 1.45995 5.40018 +2903 4 17.4096 5.93537 3.0482 10.2082 3.99522 6.08435 +2904 6 50.7076 33.0524 10.3335 3.48719 10.0002 9.95533 +2905 4 50.6136 33.804 9.75033 0.0726689 14.8217 2.89741 +2906 4 50.6632 32.3255 9.72979 -1.7797 -23.5385 -6.20373 +2907 6 28.8719 19.8379 32.3662 12.2168 9.43689 -9.94144 +2908 4 29.8293 20.0527 32.223 -26.7315 -2.75674 4.09206 +2909 4 28.3919 20.677 32.2058 6.96369 -8.55206 2.54368 +2910 6 22.4258 12.8301 23.3099 -21.9068 12.8519 23.6974 +2911 4 22.5424 12.4187 24.2055 -3.2327 9.70973 -17.8182 +2912 4 21.6904 13.4906 23.4219 18.0295 -16.5223 -3.23075 +2913 6 54.7859 15.5473 8.87871 3.42684 8.57095 -7.37477 +2914 4 0.5152 15.244 9.45304 -3.41058 -4.28924 6.32649 +2915 4 53.9742 15.1056 9.16818 6.16615 -2.4265 3.01646 +2916 6 10.455 19.2982 26.169 33.281 -8.93788 40.2277 +2917 4 11.227 18.6906 26.1605 -15.5014 12.2348 -4.03004 +2918 4 10.0694 19.2521 25.3251 -19.4777 -1.76614 -41.28 +2919 6 38.6541 20.3016 35.2246 25.1317 -2.89776 0.584273 +2920 4 39.6122 20.389 35.0245 -16.8563 1.20482 1.7302 +2921 4 38.6037 19.6498 35.9401 -3.42784 5.37932 -3.92632 +2922 6 17.4847 18.0451 15.2473 -2.11698 43.6037 15.5575 +2923 4 17.3165 17.6253 14.4157 -4.81229 -12.7227 -25.2707 +2924 4 17.3243 19.0143 15.0283 6.45297 -29.0578 8.37137 +2925 6 29.6412 0.96029 26.2538 -2.92598 -32.1867 -14.968 +2926 4 29.2295 1.80722 25.9783 -5.05853 -19.2177 -5.0061 +2927 4 29.2302 0.136786 25.7855 11.2507 47.838 14.1271 +2928 6 30.4583 12.6781 28.2933 9.80318 -11.3268 12.128 +2929 4 29.9046 13.1756 27.6811 -9.35495 -4.05719 -6.55314 +2930 4 30.1425 11.7563 28.3949 -4.92949 12.905 -7.65094 +2931 6 36.6582 22.1039 33.3564 18.5548 3.44171 -30.7077 +2932 4 37.613 21.8793 33.4826 -21.695 5.78572 4.26475 +2933 4 36.1698 21.8632 34.1249 -2.38139 -6.6943 29.4942 +2934 6 34.851 22.4634 14.295 34.3706 -12.4795 -36.6647 +2935 4 34.1306 22.5878 14.8998 -26.9044 -0.864951 1.69223 +2936 4 34.6097 22.0485 13.4154 -10.7342 10.9778 31.0087 +2937 6 15.5278 9.60588 7.43972 42.9889 -30.8008 -13.2318 +2938 4 16.5289 9.52064 7.17624 -51.4641 3.68278 11.9177 +2939 4 15.1523 8.68078 7.51431 10.3517 24.0811 1.24627 +2940 6 21.8097 28.0449 19.8036 -9.3837 2.2861 -3.69714 +2941 4 21.8234 28.4749 20.6579 1.49564 5.45585 8.79124 +2942 4 20.892 27.7474 19.715 3.3935 -2.50466 0.747966 +2943 6 34.5377 24.4067 2.43307 17.6783 -35.0943 7.08511 +2944 4 34.5604 23.3833 2.29911 9.6022 45.0517 12.0591 +2945 4 35.2671 24.6922 3.07368 -22.5652 -15.0324 -19.8681 +2946 6 12.5974 20.9324 33.5156 -46.2472 -18.3539 -4.34371 +2947 4 11.7028 20.621 33.8238 24.9199 8.0821 6.3307 +2948 4 12.4411 20.8933 32.5604 17.1824 5.4367 5.76912 +2949 6 45.7726 31.1546 8.70236 -14.9606 25.5026 -0.599968 +2950 4 45.9029 32.1319 8.75243 4.68257 -18.3747 -3.63409 +2951 4 44.8252 31.0158 8.86685 6.58294 -2.27884 -1.49072 +2952 6 15.4856 22.546 30.183 -27.3843 -7.95278 -8.87715 +2953 4 16.2041 23.1276 30.4314 15.0704 -4.03687 4.09321 +2954 4 15.7065 21.6006 30.174 10.2057 11.8959 3.83923 +2955 6 39.7496 17.1848 38.4183 10.7213 7.86871 6.49434 +2956 4 39.4778 16.5926 37.6964 5.17631 5.73732 3.80123 +2957 4 40.5328 17.6892 38.1152 -12.3514 -12.5856 -1.70264 +2958 6 14.0114 24.6894 0.67727 2.36324 3.45559 -2.63023 +2959 4 14.2236 24.5974 1.61702 0.728832 5.12592 -0.706901 +2960 4 14.3876 25.5307 0.374588 3.08684 -2.75846 6.71077 +2961 6 31.517 19.5744 3.57234 -39.7066 16.7987 -9.47084 +2962 4 30.9812 19.3042 4.35775 22.6375 1.42354 -10.5596 +2963 4 32.4299 19.3292 3.64982 19.3858 -12.3464 7.87151 +2964 6 36.0836 25.0594 19.4567 -36.7914 6.39304 28.0525 +2965 4 37.0156 25.1955 19.4145 23.7106 3.97855 -3.98164 +2966 4 35.8434 24.7134 18.6052 0.797557 -6.28507 -17.3783 +2967 6 51.6689 17.6827 14.8094 17.1445 12.5774 26.8045 +2968 4 51.9037 18.5572 15.2299 -9.72171 -22.1194 -12.5657 +2969 4 51.1779 17.9239 14.0295 -8.26923 9.08158 -15.405 +2970 6 37.7112 27.5006 38.1887 12.9616 35.4771 9.449 +2971 4 37.6633 26.7956 37.5532 1.11487 -12.4995 -15.1422 +2972 4 38.1924 28.2458 37.7567 -11.1334 -22.4905 3.32353 +2973 6 34.7974 13.8528 30.7792 38.2139 14.8122 -13.8353 +2974 4 35.0479 14.6237 31.2931 10.1718 6.91547 -1.09557 +2975 4 34.0108 13.6012 31.1887 -47.9834 -23.6229 17.9792 +2976 6 19.6227 37.378 39.9679 -4.73731 -6.94245 -18.3615 +2977 4 20.5687 37.4692 40.1123 7.88808 5.09103 7.87528 +2978 4 19.5641 36.8976 39.1176 -6.21843 3.50671 7.67834 +2979 6 40.9479 34.0678 21.4433 -0.249567 -14.1225 -18.8789 +2980 4 41.1016 33.9428 22.3797 -2.14769 -1.67588 5.36328 +2981 4 40.6839 33.1793 21.1286 -1.36491 12.9737 -0.808456 +2982 6 32.9563 27.2052 26.5619 16.765 25.3633 38.6423 +2983 4 33.6584 27.782 27.0193 -28.2502 -21.1678 -18.3317 +2984 4 33.3196 26.985 25.7164 10.2198 -2.00428 -21.725 +2985 6 24.4119 18.6722 15.6191 2.60565 2.56356 0.790403 +2986 4 23.5591 19.1036 15.7005 -5.06369 4.62453 -0.705819 +2987 4 24.5532 18.2558 16.4735 3.02917 -4.75652 8.16225 +2988 6 29.9677 1.63803 9.07283 -8.6377 39.5876 -9.34009 +2989 4 30.0634 0.720354 9.20948 2.18912 -36.9171 5.61628 +2990 4 29.1461 1.70687 8.54641 9.48634 -0.985828 6.78106 +2991 6 31.4838 20.0989 7.86304 35.53 0.0326438 -30.7549 +2992 4 32.0429 19.6076 7.17649 -26.3889 9.76992 30.1887 +2993 4 30.8408 19.4752 8.19414 -7.49558 -12.7978 -1.24617 +2994 6 35.0504 3.77818 33.2765 0.0823497 -0.922868 12.9261 +2995 4 34.3448 4.25588 32.7981 8.7563 -3.59111 2.91721 +2996 4 34.8655 3.9194 34.2319 -2.64551 -3.11561 -17.2257 +2997 6 43.9652 7.96842 12.9746 -1.99776 -12.8019 0.966431 +2998 4 43.3695 7.30717 13.3748 13.3395 3.08022 -2.86187 +2999 4 43.3917 8.71398 12.8108 -3.39849 12.2944 -1.42541 +3000 6 44.1076 32.6848 16.9531 4.83347 14.0385 -4.8226 +3001 4 44.7886 33.3699 16.7553 -9.08835 -13.3706 7.91806 +3002 4 44.1269 32.547 17.9059 1.63547 3.97279 4.50154 +3003 6 40.604 27.1617 19.037 5.49217 0.683783 -24.0967 +3004 4 39.907 26.5243 18.7614 10.7357 10.4426 0.818988 +3005 4 41.0572 27.5561 18.2306 -16.7517 -14.1941 23.9583 +3006 6 46.0503 23.2068 29.0603 33.2935 27.7725 23.492 +3007 4 46.7239 23.8517 29.4252 -26.0483 -15.0892 -12.6312 +3008 4 46.5249 22.3737 28.9794 -1.25341 -9.22801 -2.13192 +3009 6 42.6264 30.606 18.8462 -34.271 -0.881878 -8.8004 +3010 4 43.5242 30.7893 19.1074 18.3218 -5.88078 -5.57768 +3011 4 42.5428 29.9264 18.1492 10.4183 2.57162 5.03187 +3012 6 36.1231 10.8975 23.2614 14.248 33.6052 6.96597 +3013 4 35.2264 11.248 23.1278 1.11349 -2.62395 -2.03304 +3014 4 36.6438 11.7125 23.5215 -18.5882 -27.5405 -10.5609 +3015 6 13.7387 31.5187 15.7175 -8.63655 -3.85126 -4.64142 +3016 4 14.6788 31.7096 15.8046 0.813603 4.25462 -2.48371 +3017 4 13.3439 32.0503 15.0041 7.14664 -1.81478 4.34843 +3018 6 33.1663 41.4263 27.7844 10.1514 -8.73892 50.1834 +3019 4 33.0558 0.0915148 27.0508 0.335607 20.6114 -25.4934 +3020 4 33.386 0.0476391 28.6 -4.59167 -12.6797 -24.4066 +3021 6 32.8924 22.9248 31.4777 14.8331 -14.2772 -3.0724 +3022 4 32.331 22.9976 30.6823 -4.11553 14.0534 8.76104 +3023 4 32.7731 23.648 32.1168 -12.639 5.72297 -14.9522 +3024 6 27.6514 16.8629 6.392 5.9792 -3.02818 28.7598 +3025 4 27.8554 17.3015 5.57876 -0.492343 9.99532 -20.1105 +3026 4 26.7867 16.4634 6.29535 -11.4685 -3.6273 -5.68351 +3027 6 47.2692 11.6326 26.0701 -7.51592 -12.561 -4.95541 +3028 4 47.0451 11.5188 27.0189 12.1951 16.3083 -15.426 +3029 4 47.7234 12.4489 25.7723 -5.45211 -2.19527 19.0308 +3030 6 27.5533 7.05227 7.64253 19.1893 -9.34804 28.5196 +3031 4 26.7486 7.45205 7.94122 -22.9318 8.15137 -1.85106 +3032 4 28.0959 7.04706 8.46187 -1.51515 -0.839126 -23.0353 +3033 6 39.7861 9.0687 11.9758 -15.1444 6.22431 -7.98147 +3034 4 39.495 9.25597 11.0599 4.77492 -2.72739 13.3066 +3035 4 38.9879 9.23938 12.5098 3.46881 -0.389139 -2.20355 +3036 6 18.1894 33.4728 36.1008 -27.5283 -9.1571 7.06889 +3037 4 17.6722 33.9726 35.425 4.94426 -9.47891 13.9641 +3038 4 17.5468 32.9442 36.6812 19.6546 19.0371 -24.2711 +3039 6 37.1945 26.5569 0.720807 -12.4444 8.19753 -2.53971 +3040 4 37.3568 25.6462 0.476597 4.7119 -6.04631 0.679389 +3041 4 36.2336 26.6328 0.585525 8.76389 3.8419 -0.879611 +3042 6 44.2004 19.6233 36.8917 26.7932 -13.3754 0.0595121 +3043 4 45.0387 19.0956 36.766 -19.227 18.7818 5.02367 +3044 4 44.4376 20.5683 36.9644 1.27086 -9.01627 -1.91077 +3045 6 27.7799 6.35317 35.6882 16.2858 -3.70231 1.18314 +3046 4 27.1634 6.96571 35.2926 -9.46908 3.45363 -4.90602 +3047 4 27.3042 5.53742 35.858 -2.00694 0.00942349 2.38052 +3048 6 34.7653 16.4924 20.8795 20.4023 -19.0949 10.3746 +3049 4 35.5516 15.8729 20.9898 -30.5098 25.2475 -4.70775 +3050 4 34.1298 16.2162 21.5757 7.90375 5.70636 -13.0995 +3051 6 39.0303 20.9673 40.4307 -20.4786 -67.2325 12.8224 +3052 4 38.8254 20.089 40.9106 11.5443 40.6977 -30.184 +3053 4 39.2642 21.5386 41.1412 8.11615 27.562 18.514 +3054 6 10.8068 27.9205 1.65866 27.4379 7.91142 -24.506 +3055 4 10.0967 27.7204 2.22826 -30.9372 -12.069 25.0324 +3056 4 10.8782 28.8813 1.73209 2.10338 1.16742 -2.23752 +3057 6 47.025 23.1272 13.2603 -26.8307 -11.5375 0.419605 +3058 4 47.6563 23.6094 12.7175 1.22463 1.60122 -3.88323 +3059 4 46.2701 22.846 12.6737 25.4538 5.98786 18.4886 +3060 6 34.5769 28.3999 10.6617 -26.3731 9.09486 -11.6064 +3061 4 34.5145 27.7223 11.3448 13.7244 -2.44185 1.37306 +3062 4 35.5023 28.5375 10.4336 6.33869 -4.76798 1.2135 +3063 6 3.33738 17.579 14.2816 -4.12164 13.1786 -2.02309 +3064 4 3.51487 16.7052 14.5979 -0.480238 -24.8864 6.17379 +3065 4 3.96197 18.0965 14.8055 -3.35437 6.17503 -1.46632 +3066 6 27.7248 11.5976 7.52038 4.0705 34.1711 4.34085 +3067 4 27.7194 12.5939 7.6487 2.26317 -33.1326 -4.66749 +3068 4 27.2616 11.2314 8.28138 -1.22149 -2.70865 2.4378 +3069 6 41.4317 28.339 9.02961 12.1835 18.6619 -21.5911 +3070 4 40.932 28.9387 9.57928 -8.65956 3.59764 13.3257 +3071 4 41.6711 28.9179 8.26221 -0.754142 -18.9314 12.3863 +3072 6 42.0732 4.78493 8.18399 0.592074 10.501 -23.0953 +3073 4 42.2656 5.73441 7.90258 -4.03181 -32.5079 3.94615 +3074 4 41.9391 4.19656 7.39311 5.50228 24.8072 19.85 +3075 6 28.4553 8.6408 40.3288 -1.1592 2.81238 -0.593175 +3076 4 27.8014 8.47839 41.05 3.29603 2.13238 -25.5829 +3077 4 28.0374 8.68456 39.4248 -2.58083 -3.24862 30.0681 +3078 6 0.723272 18.248 15.2854 4.61761 3.31073 11.0333 +3079 4 1.58056 18.1517 14.8782 17.0637 -0.561901 -5.4503 +3080 4 0.169553 17.7112 14.727 -13.9143 -7.94922 -7.42873 +3081 6 7.11829 16.2161 40.455 0.573222 -5.60735 -16.9123 +3082 4 7.21814 15.2583 40.7035 1.10072 25.2259 14.7352 +3083 4 7.17549 16.8833 41.1741 1.82325 -21.1089 2.38217 +3084 6 41.0856 8.6232 20.9154 1.44565 10.3804 -0.748136 +3085 4 40.3857 8.53297 20.2693 -12.0873 -13.8416 -3.91841 +3086 4 41.3541 9.53003 20.731 8.87844 6.62655 8.68036 +3087 6 31.7065 7.41805 37.5384 1.8504 0.880847 10.656 +3088 4 31.4927 7.12037 36.644 -5.569 -4.06437 0.235955 +3089 4 30.9766 7.14703 38.1182 6.88034 1.43502 -8.9471 +3090 6 40.7175 11.6353 25.4105 -5.83472 20.1078 -6.29096 +3091 4 40.8441 12.5768 25.6218 -9.59803 -8.51017 -7.38463 +3092 4 41.5254 11.2592 25.7328 13.3582 -17.7026 5.353 +3093 6 29.8893 30.1615 6.66958 6.45784 -4.04896 -4.41327 +3094 4 30.5285 30.6751 6.15191 0.92206 -5.81994 -1.29615 +3095 4 30.2313 29.249 6.64761 -0.535397 8.70224 -1.24193 +3096 6 40.83 24.591 5.67679 17.1105 23.9162 -4.99229 +3097 4 41.4401 25.3556 5.89599 -18.0089 -21.1831 -4.73113 +3098 4 40.1352 24.5742 6.32932 -4.29697 2.2625 8.62223 +3099 6 34.3954 9.09122 20.4203 -0.702674 2.95809 7.47625 +3100 4 33.5897 9.50113 20.7506 -0.63314 5.38769 7.97821 +3101 4 34.107 8.76785 19.5728 -0.194313 -9.82044 -16.4611 +3102 6 18.2164 33.5433 26.5438 32.3972 -29.6611 -30.5808 +3103 4 19.1929 33.4142 26.4527 -23.3283 -2.37285 -6.48837 +3104 4 18.1915 34.0681 27.3044 -13.0981 29.1765 42.7321 +3105 6 28.9207 17.4075 26.7926 -1.66434 -4.11711 9.90999 +3106 4 28.2497 17.0259 26.21 0.151798 0.605301 -3.15085 +3107 4 28.4243 17.7127 27.5796 8.50802 -3.38176 -8.48604 +3108 6 50.4389 35.5612 18.195 -0.220837 -24.3132 -9.08897 +3109 4 50.4331 35.2145 17.2813 -0.853004 14.3463 8.17747 +3110 4 50.3692 34.7248 18.6968 -4.07606 17.1918 3.62275 +3111 6 2.99582 21.5586 31.4575 0.708202 -18.646 -28.6731 +3112 4 3.24926 22.2892 30.8424 -5.67023 -11.8068 12.1364 +3113 4 2.8516 20.7624 30.8616 4.12476 24.3831 20.6408 +3114 6 36.1857 18.7483 8.60511 9.96184 26.1081 -2.68835 +3115 4 36.1356 17.8778 8.93402 3.95956 -36.7917 21.724 +3116 4 35.6171 18.7388 7.85438 -14.2398 9.24248 -24.4438 +3117 6 20.2742 6.47995 33.7286 -0.427153 4.78104 -4.08195 +3118 4 19.8935 6.35632 34.6244 -2.14212 -11.6635 -12.611 +3119 4 20.0876 5.70362 33.1559 -1.45185 1.76636 16.8362 +3120 6 13.9952 30.5211 6.65468 -0.834568 0.374695 7.89925 +3121 4 14.6781 31.0539 7.1149 -10.4447 -7.07426 -7.17019 +3122 4 13.1432 30.7212 7.07951 7.79461 1.02333 -2.73826 +3123 6 36.2732 16.4484 35.7639 18.345 14.0335 0.961522 +3124 4 37.2268 16.2475 35.9495 -24.6333 8.21497 -3.5549 +3125 4 36.1837 17.4253 35.5797 7.74798 -29.1845 4.36862 +3126 6 45.8208 37.6575 9.69399 14.3507 -31.8621 -27.6249 +3127 4 45.4608 38.3019 10.268 -8.06385 16.394 26.7739 +3128 4 46.3975 37.0305 10.1733 -1.81999 10.6315 0.898341 +3129 6 47.4165 17.984 27.6369 4.10759 -46.3966 -5.45297 +3130 4 47.5682 17.4629 26.7823 -7.01073 17.4072 30.8444 +3131 4 47.4562 17.3293 28.4007 0.542452 20.9274 -25.5144 +3132 6 25.9608 18.2932 0.952258 -4.39486 21.5955 18.9376 +3133 4 26.1989 18.9101 1.66086 12.5057 -8.35286 -7.15646 +3134 4 25.0082 18.3237 1.04468 -12.1408 -13.2893 -13.6751 +3135 6 27.3648 22.4066 4.28268 2.26175 -24.9034 0.419816 +3136 4 27.3706 23.3409 4.46802 1.80952 16.8807 -5.51915 +3137 4 27.3027 22.2785 3.32806 -2.77408 5.10873 4.5687 +3138 6 3.39125 3.84856 27.607 3.69966 -10.1033 0.490887 +3139 4 4.0137 4.55908 27.5406 6.78149 24.6072 0.911673 +3140 4 3.97847 3.09168 27.5281 -8.4044 -12.3732 0.103181 +3141 6 45.3633 27.6554 28.8452 2.12727 -1.25659 10.7713 +3142 4 44.5282 27.2015 28.6866 -4.83999 -4.58212 3.48715 +3143 4 45.3811 28.2979 28.14 4.63148 6.41932 -6.37453 +3144 6 28.4005 32.3772 16.2203 23.7034 -3.75626 0.763822 +3145 4 29.2297 32.2225 15.6968 -18.0553 4.16843 14.9752 +3146 4 28.6795 32.6874 17.1033 -0.325788 -1.29005 -11.6373 +3147 6 9.90477 33.835 13.0292 3.70295 -3.7397 30.9684 +3148 4 9.58558 33.3049 13.7992 6.56164 12.5415 -12.6178 +3149 4 9.32425 33.6546 12.2978 -12.2649 -3.83445 -16.8068 +3150 6 38.3301 26.6316 14.917 8.16845 -9.374 -1.40965 +3151 4 38.7482 25.7736 15.154 -10.3234 14.7528 -2.05039 +3152 4 37.3847 26.6122 15.1206 3.66029 -5.29 2.35016 +3153 6 31.3553 16.3729 4.24558 -11.5598 -13.3523 13.2112 +3154 4 30.5395 15.8971 4.54084 13.4071 7.11555 -7.19651 +3155 4 31.205 16.607 3.32285 -2.62497 2.93757 -4.30077 +3156 6 6.17611 3.41063 6.5613 17.7272 3.64487 37.5473 +3157 4 6.46982 3.08663 7.46094 -9.0795 17.2981 -27.883 +3158 4 6.02642 2.6045 6.08389 -2.81663 -13.5692 -12.3872 +3159 6 42.5919 12.9938 5.62253 0.302259 -11.3067 -0.460125 +3160 4 42.3001 13.8766 5.84478 4.87778 6.39543 1.2284 +3161 4 43.5084 12.9049 5.92305 -2.35353 0.46184 -1.33783 +3162 6 41.0467 31.3953 33.7949 3.79599 37.3117 5.16998 +3163 4 40.7289 31.3961 34.7173 5.05156 -5.30154 -15.2916 +3164 4 41.2174 32.3636 33.5809 -4.47671 -37.1445 4.47908 +3165 6 52.8595 12.0576 26.2617 4.7779 -12.5882 -49.4794 +3166 4 52.3971 12.713 26.7564 -13.8804 18.303 15.9364 +3167 4 52.6839 12.2865 25.2977 8.87889 -9.64762 29.5111 +3168 6 39.2197 4.29237 29.0569 11.235 6.95972 3.08537 +3169 4 38.4782 4.84799 29.3396 4.36118 -6.50894 -4.0878 +3170 4 39.9967 4.59393 29.5615 -4.77927 -7.36273 -4.89832 +3171 6 3.64414 27.0065 11.2815 -12.9441 10.9516 -6.43872 +3172 4 4.59106 26.8908 11.2849 14.3058 -9.72403 4.26042 +3173 4 3.53535 27.8319 10.7781 -8.82957 -2.80904 -0.131447 +3174 6 41.5421 29.6442 25.2671 -5.6293 3.19366 2.66863 +3175 4 41.8684 29.6903 24.3723 12.1179 -3.11764 -10.4285 +3176 4 40.7194 30.1326 25.2057 -6.30215 2.63585 1.74894 +3177 6 50.468 27.487 30.6705 -3.05594 -10.4468 2.57161 +3178 4 50.076 27.1594 31.5009 0.806547 4.01213 -5.24181 +3179 4 49.8217 28.0451 30.2184 -2.62753 1.96724 1.87939 +3180 6 32.7902 33.6258 41.7496 -4.87138 -4.97834 -25.0012 +3181 4 33.1641 32.7497 41.8541 3.47816 -11.5824 1.65798 +3182 4 32.8969 34.0586 0.665858 3.16614 12.7166 21.4132 +3183 6 5.9796 9.64598 7.93234 5.57207 13.1841 -10.7861 +3184 4 5.80592 9.95912 8.82583 -0.986272 -0.521215 4.5825 +3185 4 6.43021 10.3852 7.47125 -1.05258 -10.6241 3.31462 +3186 6 52.774 25.3768 27.6816 12.7732 -3.18466 28.0173 +3187 4 52.93 26.2779 28.0237 -8.60677 -10.695 -13.1321 +3188 4 53.2011 24.8527 28.4031 -8.37753 -2.27765 -26.5487 +3189 6 18.6947 23.2095 14.4724 -28.0966 8.43578 15.8218 +3190 4 18.5587 24.1605 14.7523 20.6562 -24.296 -13.1918 +3191 4 19.5669 23.0215 14.1303 11.4888 10.4676 -1.8787 +3192 6 31.2862 9.0706 13.0896 18.8649 -43.5027 -8.26415 +3193 4 31.2854 8.18164 13.5153 -0.98006 14.2242 -7.24428 +3194 4 30.8139 9.64196 13.6614 -21.2648 23.3567 24.384 +3195 6 52.8349 16.8368 29.9626 -1.04236 -5.83632 -3.7224 +3196 4 53.1314 16.3317 29.1809 4.11254 10.2245 6.81583 +3197 4 53.5336 17.4658 30.2088 5.59995 -2.32318 -6.64835 +3198 6 13.48 30.6403 11.9185 -26.7 12.8254 18.6299 +3199 4 12.8874 31.2649 12.4086 6.11749 -21.3055 -11.69 +3200 4 14.2712 31.1662 11.9231 18.3999 3.72963 -5.07782 +3201 6 24.4118 24.6653 11.1776 -11.0488 -38.9105 0.0232616 +3202 4 25.2327 25.0345 11.4834 15.6111 8.28781 8.86477 +3203 4 24.5324 23.6736 11.237 -9.01076 27.817 -2.51724 +3204 6 11.1207 26.7925 5.93063 -6.41259 2.09364 -8.23675 +3205 4 11.5241 26.98 6.79711 -3.12879 8.72791 -6.17468 +3206 4 10.8719 27.6544 5.50988 6.7003 -18.2386 15.7162 +3207 6 12.0069 32.3194 4.56559 -6.93674 1.89769 -53.2748 +3208 4 11.7104 31.8608 3.68045 16.1117 25.2499 46.2442 +3209 4 12.3686 33.2222 4.3326 -9.20365 -26.1492 2.14142 +3210 6 6.43611 5.48582 30.4705 10.9412 7.27018 -5.81208 +3211 4 6.8324 6.31983 30.1884 15.302 -0.761667 0.276275 +3212 4 5.5204 5.70213 30.4126 -22.6187 -2.98333 3.5448 +3213 6 38.1723 39.6045 29.3805 -11.1368 -0.968084 -7.99101 +3214 4 37.5332 40.3179 29.1036 12.1085 -24.1545 -0.917311 +3215 4 37.9804 38.7063 28.9788 -2.28765 36.4506 5.30967 +3216 6 52.5924 19.3736 5.41149 4.12965 0.0949992 -5.17576 +3217 4 52.3027 20.2712 5.07121 22.7239 -28.0308 -2.84369 +3218 4 53.4989 19.0543 5.10701 -28.7609 25.7225 2.66162 +3219 6 18.3561 9.81057 21.0683 -18.476 -24.6523 15.6829 +3220 4 17.6378 9.45854 20.4828 20.1245 14.4878 5.80252 +3221 4 19.033 10.2869 20.5982 6.82627 10.6552 -20.9713 +3222 6 14.5094 41.1238 15.0395 5.73538 -4.06503 -13.1796 +3223 4 15.2839 41.068 15.6075 4.55031 0.900939 7.74817 +3224 4 13.875 41.6599 15.5263 0.0235554 2.15182 4.98288 +3225 6 36.0027 23.903 26.7597 7.48895 21.6763 -35.676 +3226 4 35.8975 23.6043 27.6465 2.36908 -17.7227 17.2904 +3227 4 36.3267 23.2124 26.1374 -7.97178 4.49324 27.7844 +3228 6 35.6359 10.4157 26.2529 -13.2839 -25.1837 23.1485 +3229 4 35.969 10.5098 25.3716 5.3977 0.436992 -21.1808 +3230 4 35.4229 9.45302 26.3798 5.18698 20.1527 -7.56493 +3231 6 45.3037 24.2791 20.2723 9.06075 11.2998 -13.4968 +3232 4 45.4523 24.978 19.6109 10.2075 -1.49386 4.95329 +3233 4 44.5125 23.8555 19.9662 -13.3892 -9.58217 -2.04663 +3234 6 15.8107 39.0453 24.2393 9.7405 19.086 8.48056 +3235 4 15.3407 39.8143 24.6455 3.07287 -17.6695 -6.90152 +3236 4 16.7434 39.3626 24.1878 -22.1708 -8.11019 0.25747 +3237 6 4.61074 25.9041 16.8066 4.47487 12.325 4.32837 +3238 4 5.33363 26.3313 17.2996 -1.16871 -8.95741 -3.63592 +3239 4 3.89121 26.5439 16.91 5.27726 -3.71411 -3.28281 +3240 6 33.4791 9.99232 32.5716 -36.5508 -4.76722 -31.2046 +3241 4 34.3147 10.2419 32.89 39.2476 10.968 21.6954 +3242 4 33.0188 9.57531 33.3002 0.324125 -5.12222 10.2577 +3243 6 22.9388 37.5185 1.51191 -4.27166 -24.2064 8.31852 +3244 4 23.0334 38.2273 2.154 1.20614 3.86272 6.71724 +3245 4 22.69 36.6978 2.02191 6.96614 23.4315 -10.5782 +3246 6 39.1324 20.5485 25.4772 25.265 -11.778 19.9951 +3247 4 39.2103 21.4279 25.1215 -1.526 12.0473 -3.88318 +3248 4 39.8813 20.4818 26.1301 -17.748 -0.0581828 -14.4699 +3249 6 25.0622 25.0762 37.6014 21.4558 5.76047 -13.7935 +3250 4 26.0349 25.2337 37.6294 -19.4467 -8.38624 -4.14531 +3251 4 24.8891 24.8197 38.5048 -7.65564 -1.94532 12.2316 +3252 6 12.209 35.7591 11.4203 -9.12536 1.25056 -5.53999 +3253 4 11.4995 36.2015 10.8899 19.2305 -11.6187 8.3526 +3254 4 12.8486 35.4161 10.7797 -5.71729 7.89629 -2.43108 +3255 6 42.046 15.7235 20.1276 29.9467 5.46844 -26.2367 +3256 4 42.5818 15.5034 19.3148 -14.0105 1.75231 17.5608 +3257 4 42.3615 16.6209 20.337 -4.0808 -2.27778 2.90042 +3258 6 53.2021 25.4307 39.5282 4.69599 -13.2561 7.07883 +3259 4 53.78 25.8541 38.905 5.49131 5.5629 -6.42231 +3260 4 52.4802 26.028 39.6966 -10.1139 9.50655 0.821399 +3261 6 53.7967 21.778 1.29815 15.5744 -8.20383 1.43914 +3262 4 54.6378 21.4326 0.944441 -3.84265 -1.46767 8.18122 +3263 4 53.3536 22.1543 0.542634 -13.037 9.31425 -11.6048 +3264 6 1.93111 22.4438 20.1768 4.00387 4.12813 31.1185 +3265 4 1.5939 23.2361 20.6593 2.49828 -13.4199 -15.2591 +3266 4 2.41139 21.9607 20.8911 -6.34657 6.89732 -14.8434 +3267 6 41.1871 16.1847 11.4932 0.836017 42.0531 1.99799 +3268 4 40.9413 15.3195 11.802 -9.8633 -17.6073 7.87469 +3269 4 40.5377 16.8617 11.8588 16.4331 -27.7799 -8.96912 +3270 6 17.194 38.6096 9.61825 4.75854 -2.20459 -16.4638 +3271 4 17.8324 38.6167 10.328 10.0816 -0.610832 12.429 +3272 4 16.3385 38.6013 10.0398 -14.9506 0.593169 11.9887 +3273 6 33.2005 12.9606 38.531 8.50507 10.8774 -15.8661 +3274 4 33.6532 13.8203 38.39 -7.98235 -13.7359 5.26797 +3275 4 33.1331 12.8007 39.479 5.11874 5.24255 -4.23095 +3276 6 24.7171 21.675 39.9778 2.8762 -23.2501 -10.2076 +3277 4 24.5558 21.597 39.0096 0.45736 0.189324 11.8412 +3278 4 25.3262 20.9394 40.2143 -5.83632 9.86919 -3.30671 +3279 6 13.5803 15.5602 27.3532 26.1047 30.3564 11.1382 +3280 4 13.1676 16.145 28.014 -3.26959 -8.19558 -5.9347 +3281 4 12.973 14.8589 27.1951 -20.4184 -17.1677 1.43072 +3282 6 24.68 18.7128 9.26691 14.3839 36.3501 26.0009 +3283 4 25.3598 19.2552 8.82532 -5.31062 -15.6251 -9.27674 +3284 4 24.5166 19.2286 10.0937 -4.12977 -20.8661 -14.1648 +3285 6 10.971 8.2031 0.0820528 -5.05885 27.6393 52.7366 +3286 4 10.426 8.82187 0.676738 20.6953 -23.692 -21.2054 +3287 4 11.8511 8.19112 0.51746 -10.8092 -0.715691 -8.01276 +3288 6 15.7168 31.9426 31.3882 -16.0589 -14.8784 11.374 +3289 4 14.8784 32.0139 30.9212 -5.19427 4.39929 -5.1125 +3290 4 16.2361 32.7208 31.1626 4.51908 -4.85975 -1.07492 +3291 6 20.3853 39.1678 21.6201 3.96912 1.70678 -2.15463 +3292 4 19.8408 38.4031 21.9136 18.3946 15.2484 5.21077 +3293 4 21.1259 39.3411 22.2478 -18.5683 -14.4588 -3.61544 +3294 6 38.8575 19.5345 7.60357 -3.22682 7.2187 -10.7103 +3295 4 37.9955 19.1157 7.58645 -3.56529 1.50397 -1.646 +3296 4 39.2183 19.2349 8.43232 7.58358 -7.76078 7.45775 +3297 6 41.3566 29.7161 21.1634 -18.4754 -13.1658 17.2704 +3298 4 41.7904 29.7702 20.3348 3.95998 3.00501 -30.3792 +3299 4 42.0386 30.0045 21.7486 9.4821 7.67994 22.7786 +3300 6 50.7055 33.8359 22.0677 10.0235 -14.5617 12.8511 +3301 4 51.0634 32.983 22.4061 -4.7136 19.0099 -8.42991 +3302 4 50.4062 33.6539 21.1646 0.0172424 0.211956 1.78818 +3303 6 18.1576 11.1602 14.3564 -14.1594 -3.53412 4.86119 +3304 4 18.0624 11.3441 15.3149 3.69196 -2.83217 -14.991 +3305 4 19.1071 11.0831 14.1997 2.21718 -0.861887 0.62752 +3306 6 48.509 14.2737 15.2536 -33.8512 -15.7039 -13.3543 +3307 4 49.4102 14.4821 15.4142 31.3042 4.03673 3.1002 +3308 4 48.4635 13.5769 14.5611 0.497508 10.2707 10.4073 +3309 6 32.9892 15.7452 8.24788 15.5762 1.59093 3.47394 +3310 4 33.8184 15.532 7.78513 -5.99942 0.288096 4.45585 +3311 4 33.1922 15.7362 9.20789 -3.05234 -0.622843 -13.6288 +3312 6 42.9176 4.85532 18.7629 14.1748 1.41964 3.40057 +3313 4 42.9882 5.82921 18.9229 4.77982 -22.1758 1.39114 +3314 4 43.8043 4.45344 18.9624 -18.3785 17.0247 -7.93082 +3315 6 10.5031 23.7237 33.4382 -0.874073 19.9298 2.74355 +3316 4 10.5548 24.717 33.3795 7.7257 -28.8706 -7.54496 +3317 4 11.1379 23.281 32.8547 0.735263 11.3428 1.89897 +3318 6 1.13216 20.0583 11.2836 18.374 17.5884 12.1148 +3319 4 0.491024 19.3349 11.1994 -2.17247 3.20995 10.4498 +3320 4 1.13554 20.5377 12.169 -13.4236 -25.5013 -29.3002 +3321 6 1.52072 39.5358 14.3069 -1.86369 -19.4721 11.7014 +3322 4 0.846705 40.1803 14.5938 4.14733 -5.95668 -5.60613 +3323 4 1.29368 38.6598 14.724 6.32152 28.9753 -9.07681 +3324 6 8.31775 21.6111 14.1387 -15.017 -6.93379 31.3726 +3325 4 8.13664 21.1659 15.0266 4.22851 15.111 -30.7591 +3326 4 7.52757 21.5034 13.5919 -1.9589 1.09648 1.01763 +3327 6 7.16491 13.3069 38.2405 -3.91014 1.61314 -29.5843 +3328 4 6.63698 13.0539 37.4502 4.01765 -4.94514 23.7112 +3329 4 7.51249 14.1719 37.966 2.17516 -8.38294 10.659 +3330 6 46.6268 1.62726 18.6981 -5.20766 -2.9114 16.5849 +3331 4 47.5711 1.68468 18.9367 -9.38594 -0.162468 5.90612 +3332 4 46.1191 1.48652 19.5414 20.1897 3.23395 -16.531 +3333 6 4.07867 8.38347 14.797 30.0262 18.9917 2.43531 +3334 4 3.34187 8.3175 15.3794 -25.1937 -7.21885 10.0707 +3335 4 3.92422 7.81173 14.052 -7.87119 -13.0009 -15.9092 +3336 6 47.5843 36.535 17.848 27.4213 12.0237 5.93301 +3337 4 47.2301 35.69 17.6416 -25.9655 -28.1947 -7.00186 +3338 4 48.5203 36.321 17.8356 11.6458 7.4707 2.49139 +3339 6 48.7172 32.6081 3.62434 16.9155 19.6851 -27.3563 +3340 4 49.4676 32.1613 3.18145 -8.8052 -0.0369675 17.0972 +3341 4 48.3534 32.1141 4.33579 -5.12692 -24.8974 22.5299 +3342 6 26.8624 34.4063 15.194 -5.61502 8.38998 -0.355377 +3343 4 27.128 33.6719 15.7603 3.91671 -4.37186 -8.54489 +3344 4 27.3784 34.3384 14.3661 -3.09932 -5.4603 13.6569 +3345 6 9.98983 27.3411 13.3236 -5.30345 -60.6937 -19.0037 +3346 4 9.94192 28.2179 13.0053 -1.51785 37.2293 -13.4128 +3347 4 9.87191 26.7487 12.5139 4.66007 24.2176 27.9858 +3348 6 2.39898 26.8872 37.357 1.59401 -7.29113 19.9813 +3349 4 2.39832 26.7504 38.3162 -5.28205 -0.510768 -0.23331 +3350 4 3.33711 26.9514 37.1904 14.8183 3.44774 -11.9786 +3351 6 33.3368 17.2756 36.8005 -23.2882 7.84328 1.94786 +3352 4 32.371 17.4043 36.8526 5.24602 0.476467 11.7287 +3353 4 33.4423 17.1515 35.8622 12.5187 -3.29866 -15.2334 +3354 6 10.6624 18.8035 9.30575 -3.98781 15.2275 -14.7508 +3355 4 10.7339 18.764 8.32616 -2.59554 -5.92059 15.2764 +3356 4 10.8972 19.732 9.49452 -1.55193 -6.4517 3.37647 +3357 6 8.57833 27.4047 3.14019 -5.09403 -6.13324 -2.85576 +3358 4 8.57126 27.6547 4.08504 -2.7611 -8.03155 -6.83353 +3359 4 8.4622 26.4231 3.09919 3.19624 23.0742 12.9307 +3360 6 40.6073 33.9264 14.3399 -6.85038 20.2562 -23.9123 +3361 4 40.863 33.245 14.948 0.807967 -8.16399 15.1571 +3362 4 40.0779 34.5716 14.8204 -0.495244 -4.69725 4.10141 +3363 6 53.9925 16.7992 13.6308 6.31935 -7.9338 28.1888 +3364 4 54.0997 17.1551 12.7528 -11.031 14.1585 -18.9596 +3365 4 53.1709 17.0486 14.0912 -3.14305 7.59696 -13.573 +3366 6 39.1497 38.4912 7.40608 -39.1223 4.05884 30.5073 +3367 4 38.8859 38.5922 6.48797 -2.00378 4.08479 -3.77896 +3368 4 38.3062 38.5986 7.97667 35.5804 -2.74434 -28.8566 +3369 6 42.2129 33.6808 29.0138 -24.1371 3.42921 -11.8129 +3370 4 42.1057 34.6378 28.7577 -2.98627 -25.8941 0.854821 +3371 4 41.3475 33.1819 28.8496 28.8118 27.0492 8.45917 +3372 6 2.85866 0.0629173 20.1315 -20.2536 1.52979 -19.4947 +3373 4 2.75203 0.421025 19.2221 8.85994 -2.20895 9.93397 +3374 4 1.96017 41.6124 20.299 15.6791 2.4666 6.01858 +3375 6 24.986 26.9373 24.4454 -5.13687 18.0728 7.96565 +3376 4 25.2851 26.0172 24.3926 4.88984 -3.86206 4.04103 +3377 4 25.2923 27.4081 25.2509 0.579281 -17.4573 -11.648 +3378 6 13.6179 33.9875 7.01366 -9.87556 12.4155 -39.0476 +3379 4 14.4287 33.6264 6.65472 5.99816 -4.92128 6.68342 +3380 4 13.2096 34.3429 6.17379 4.4552 -5.00021 31.0775 +3381 6 17.6494 31.8378 3.38868 3.47258 32.8259 -24.0658 +3382 4 17.3179 32.0585 2.49435 6.00696 -1.44586 18.975 +3383 4 17.3532 30.9566 3.5196 -11.0767 -31.773 11.9025 +3384 6 31.1111 29.8483 35.9167 13.6376 7.61418 -14.6842 +3385 4 30.4141 29.611 36.5018 -19.519 -6.65958 16.6428 +3386 4 31.8988 29.4329 36.2727 4.98993 0.410401 2.8928 +3387 6 31.4643 1.69164 1.93808 20.5111 47.6543 28.2436 +3388 4 30.8038 1.05919 1.86135 -35.916 -50.7273 -13.0106 +3389 4 30.9957 2.32106 2.5233 13.9145 -2.66096 -10.7861 +3390 6 13.7147 9.36591 12.3063 -10.8769 -31.3803 3.40225 +3391 4 14.006 10.2311 12.0687 5.19854 25.7457 4.3425 +3392 4 13.2135 9.34561 13.1466 7.78847 9.513 -6.56361 +3393 6 15.2882 15.1512 12.1315 -28.7349 -8.10496 1.75886 +3394 4 14.285 15.1274 12.2085 32.3197 -4.02875 -3.81405 +3395 4 15.5527 14.5676 11.4001 -6.69875 1.91641 1.76342 +3396 6 44.9132 30.4441 13.088 -39.1187 -0.31911 18.6923 +3397 4 45.3561 30.6438 13.8967 -2.95974 2.37903 28.1101 +3398 4 45.6316 30.4633 12.5179 38.3165 -3.24606 -51.9295 +3399 6 35.1465 37.623 24.8576 -14.1582 -15.7359 28.7413 +3400 4 34.5779 38.3725 25.1706 10.6028 -16.3472 -5.82963 +3401 4 34.9593 36.856 25.4995 5.71155 29.9045 -22.7235 +3402 6 43.8948 19.2936 12.9987 -2.30513 -18.2146 13.0469 +3403 4 43.787 18.3102 12.9069 2.76315 21.1578 4.09431 +3404 4 44.375 19.4187 13.8444 -6.58761 -4.34429 -6.9628 +3405 6 14.1971 27.3925 16.8971 2.69526 11.3314 -20.1154 +3406 4 13.4533 26.7979 16.9981 -2.42546 -10.6182 5.16389 +3407 4 14.0783 27.734 15.9851 5.1255 -3.8968 13.4589 +3408 6 5.08574 37.4729 15.7377 1.34169 3.72011 38.8669 +3409 4 5.88395 37.4897 16.2981 -4.65405 2.63162 7.63907 +3410 4 5.46406 37.2335 14.9215 11.9791 -13.9554 -41.5179 +3411 6 35.4862 36.9766 33.2333 -36.83 -5.70901 2.9599 +3412 4 36.4114 37.1444 33.1615 28.5824 10.2327 4.96708 +3413 4 35.1164 37.4942 33.9725 5.15458 -1.79752 -2.84758 +3414 6 6.636 31.7097 32.9848 -22.7133 -7.33235 -24.9389 +3415 4 7.22761 30.9741 32.8206 4.14198 -5.34147 5.16294 +3416 4 6.9999 32.2337 33.6789 14.5784 9.31919 13.8511 +3417 6 31.283 20.2175 25.4647 -9.91499 -1.61286 9.73388 +3418 4 30.5344 20.24 26.1037 18.6204 0.149313 -5.83605 +3419 4 30.8734 20.4846 24.6365 -0.167457 4.09649 -2.99843 +3420 6 54.9487 26.0868 7.35258 -28.6285 -0.216784 1.76255 +3421 4 54.2955 26.5615 6.794 6.74078 -5.97369 7.99882 +3422 4 54.4034 25.6757 8.0611 9.89476 6.61779 -10.5703 +3423 6 17.8651 35.1614 24.3791 -20.7499 -4.98646 -29.5673 +3424 4 18.0576 34.6235 25.1649 -8.37985 -1.7243 -11.1178 +3425 4 17.2007 34.681 23.779 26.831 10.1018 28.2803 +3426 6 49.1285 3.31358 19.7417 -8.45795 -3.91869 -17.1851 +3427 4 48.8119 4.11203 20.1653 -3.29153 9.9905 4.05996 +3428 4 49.7807 2.96094 20.3466 4.32541 -4.85853 3.16639 +3429 6 30.2844 35.6035 13.4934 7.2001 -0.317469 -2.452 +3430 4 29.4623 35.659 12.9857 1.71884 -1.71824 2.45729 +3431 4 30.0585 35.4328 14.4204 -4.00669 1.3983 -5.34585 +3432 6 43.3887 25.8808 41.6785 -22.9069 -12.3923 -2.55701 +3433 4 43.9997 25.6768 40.9817 12.0928 0.211006 -14.0269 +3434 4 43.8339 26.4255 0.397834 14.8568 14.8319 19.2759 +3435 6 21.0884 23.1529 6.38678 -1.35916 1.28851 13.8592 +3436 4 21.4 23.8645 6.98768 -5.78702 -12.5756 -9.70729 +3437 4 21.3246 23.4545 5.51028 2.40121 5.3387 -13.5131 +3438 6 54.6143 21.1989 19.0895 1.0726 18.3039 13.0104 +3439 4 0.43531 21.5582 19.5367 -15.0683 -8.68203 -12.1911 +3440 4 53.867 21.7044 19.4937 16.3508 -9.47613 -7.9193 +3441 6 13.877 38.9443 18.7624 -3.57764 -10.5141 -5.7706 +3442 4 13.4493 38.4672 19.4981 1.6116 7.10734 -3.21136 +3443 4 14.0821 39.8514 19.0249 -5.40993 2.00969 6.25434 +3444 6 39.1872 2.73234 39.6824 0.14108 0.727177 -8.14712 +3445 4 38.529 2.27328 40.2354 4.03816 -1.16808 -5.22543 +3446 4 39.0548 2.41866 38.7627 -6.48078 -0.982324 12.2661 +3447 6 43.2185 33.8148 8.84061 -19.4182 46.8926 -2.36482 +3448 4 43.1772 32.9719 9.24022 -1.50187 -35.3898 17.2737 +3449 4 42.5163 34.3616 9.29053 19.0727 -15.0644 -10.6104 +3450 6 23.089 16.6827 12.1027 15.7208 -3.2574 -7.89972 +3451 4 23.4385 16.1911 11.3228 -11.6069 8.24456 13.4993 +3452 4 22.136 16.8018 11.9813 0.424679 -1.38664 -3.29845 +3453 6 40.7855 26.1389 36.3196 -19.9126 19.309 9.87347 +3454 4 40.0986 26.8534 36.2514 19.4153 -21.5003 1.38126 +3455 4 41.1517 26.0031 35.4437 4.25962 0.995192 -8.54639 +3456 6 15.1503 11.6717 19.2973 0.724699 -1.19191 17.6918 +3457 4 15.5299 12.2877 18.6792 5.27756 8.7759 -18.41 +3458 4 15.4868 12.0294 20.1269 -4.65024 -4.08223 3.58338 +3459 6 9.86165 29.8154 31.387 -8.94942 -10.7424 5.06077 +3460 4 10.5846 30.1184 31.9716 0.245343 7.83947 -17.0155 +3461 4 9.856 30.1645 30.4637 12.8302 0.479173 21.4055 +3462 6 2.12473 30.035 25.2763 1.78753 8.3758 2.85176 +3463 4 2.08519 29.2167 25.7943 1.54705 3.16986 -12.4779 +3464 4 2.12365 29.8679 24.3136 0.147535 -6.31004 19.3474 +3465 6 49.0081 10.6471 7.05663 3.22839 15.7191 0.010386 +3466 4 49.8069 10.5015 7.59507 -11.7369 -5.9273 -2.35907 +3467 4 48.4474 9.86293 7.09337 3.15572 -10.0552 5.75386 +3468 6 38.6524 34.4248 32.4903 14.0617 12.8107 -4.97275 +3469 4 38.3124 35.2999 32.7524 2.4491 -7.54743 -1.61947 +3470 4 38.3152 33.7696 33.1015 -5.90625 -1.07654 6.02858 +3471 6 24.2925 24.7077 4.76791 -9.60212 12.423 13.627 +3472 4 24.6592 23.9059 5.14091 6.4374 -12.2494 -4.05598 +3473 4 24.0877 25.2629 5.55261 2.76703 -5.61196 -18.2913 +3474 6 44.0394 23.5955 33.7722 -22.1761 -10.7316 25.8053 +3475 4 43.54 23.0408 33.1405 14.8275 10.6039 0.934173 +3476 4 44.7909 24.0173 33.3845 18.136 8.68259 -21.6513 +3477 6 45.1404 31.9557 26.6336 7.63501 -16.8517 -19.5705 +3478 4 44.7419 32.078 27.4825 -5.98757 6.26965 19.5048 +3479 4 44.9572 31.0195 26.4087 0.928196 13.8489 4.22851 +3480 6 52.067 6.35346 22.8527 -23.4258 -19.9992 -0.226773 +3481 4 51.4359 5.65775 23.1792 22.6487 15.1416 -4.78776 +3482 4 51.473 7.11391 22.7826 5.97124 1.02094 -2.8274 +3483 6 5.11659 17.7141 30.4608 -43.6072 -14.7819 8.36724 +3484 4 5.56343 17.5578 29.6371 20.9412 3.52217 -11.7922 +3485 4 5.63141 18.2128 31.0754 22.7819 13.5036 5.79607 +3486 6 48.537 17.0137 6.52887 28.2349 12.1042 -25.3981 +3487 4 48.2628 16.1023 6.56372 -5.81913 -12.4107 2.5618 +3488 4 49.2494 17.0592 5.82246 -25.6562 2.24824 21.9849 +3489 6 13.808 31.3142 23.4689 -3.64011 -9.68131 26.3432 +3490 4 14.1349 31.2178 24.3617 -12.0329 4.75192 12.2102 +3491 4 14.6149 31.173 23.0226 30.8248 -5.26015 -34.1434 +3492 6 28.4946 33.4369 26.0285 16.4638 25.2333 -6.25798 +3493 4 28.7216 32.7387 25.4298 8.48672 -9.67688 -13.795 +3494 4 27.7897 33.0868 26.5316 -24.4903 -9.494 23.2581 +3495 6 9.0435 22.9594 11.008 21.162 0.605596 1.29652 +3496 4 9.33306 22.7779 10.1087 -4.82127 0.713158 -4.26872 +3497 4 9.8456 22.7632 11.5172 -9.5186 2.48902 2.0044 +3498 6 40.5545 4.06728 26.5809 44.6249 -53.7912 6.90123 +3499 4 40.0988 4.06982 27.4038 -17.0162 4.47424 24.8249 +3500 4 40.1579 4.71783 26.0744 -31.5116 46.4114 -32.7723 +3501 6 17.0554 37.9737 20.9489 23.2001 5.84937 -15.1211 +3502 4 17.8184 37.6206 21.4529 -18.1961 -0.773306 2.14347 +3503 4 16.241 37.9215 21.4323 -8.54619 -6.77157 16.0583 +3504 6 31.9589 6.36634 14.2007 -32.7312 -5.18635 1.31695 +3505 4 31.6173 5.45206 14.3159 2.63352 8.72785 -2.4018 +3506 4 32.9006 6.25378 14.1536 18.2531 -4.45925 -0.605861 +3507 6 29.3682 34.9487 39.6588 1.61784 2.82525 -17.5597 +3508 4 29.3689 34.7576 40.5935 -6.77547 -0.101859 12.4897 +3509 4 28.4273 35.0463 39.4168 8.43037 -3.37269 4.33216 +3510 6 22.5699 2.93494 32.1141 -1.63629 -8.86743 4.25418 +3511 4 23.0898 3.67063 31.7669 1.49018 1.71101 -1.29845 +3512 4 22.818 2.15292 31.5827 -1.92581 11.5593 5.09528 +3513 6 51.7444 19.0899 24.8018 18.5566 14.3159 27.8709 +3514 4 52.1262 19.3991 25.6728 -16.855 -8.06891 -29.5747 +3515 4 52.1578 19.634 24.1129 -3.61196 1.33098 2.20453 +3516 6 32.1137 13.664 24.2226 6.2567 1.72658 -37.8727 +3517 4 32.2307 13.7857 25.1378 6.97488 6.10606 45.7276 +3518 4 31.1794 13.5551 24.0935 -22.8325 -3.39176 -1.92521 +3519 6 9.48788 30.1788 28.8037 -7.90151 -0.480281 -10.0021 +3520 4 9.04214 29.3907 28.4657 0.296662 -4.58444 4.12418 +3521 4 9.71381 30.648 27.9899 1.85323 2.91474 4.33114 +3522 6 31.3027 3.12343 24.087 3.70677 4.08208 -3.18372 +3523 4 30.8363 3.94541 23.9161 -7.21645 -1.79011 2.75115 +3524 4 32.1629 3.26377 23.6687 3.35255 -5.74571 3.4439 +3525 6 2.14326 19.8385 36.4613 43.5578 -10.0216 -16.9659 +3526 4 3.05142 19.7594 36.0352 -31.8637 8.98539 19.2185 +3527 4 1.69253 19.0555 36.1346 -14.6763 0.545221 1.96285 +3528 6 36.957 16.7591 14.0918 2.96563 -13.2358 -6.51153 +3529 4 37.0513 17.1687 14.9682 1.23982 -3.45998 -2.6752 +3530 4 37.3406 15.8552 14.1067 -4.20166 12.9403 2.86695 +3531 6 1.82327 11.1921 6.0808 -0.275886 9.47834 -4.04825 +3532 4 1.66503 10.3513 6.51275 0.636708 -7.94921 -0.277572 +3533 4 1.41092 11.8149 6.68093 -3.53423 6.76721 2.7814 +3534 6 43.1526 36.8455 25.2619 -8.14588 -11.3328 3.19442 +3535 4 42.3648 36.774 24.6888 4.17675 -0.750929 11.0286 +3536 4 43.0263 36.2034 25.9927 3.18182 11.8936 -13.2388 +3537 6 32.1279 5.54767 7.01242 2.49094 2.37791 -5.83138 +3538 4 31.9279 4.68363 7.38152 0.218816 -4.41428 4.71371 +3539 4 31.563 6.18782 7.45455 -6.02642 2.24751 5.27561 +3540 6 15.066 21.4965 41.5173 26.6113 -14.2353 0.879596 +3541 4 14.4098 21.4318 0.299313 -13.8163 5.2854 1.00244 +3542 4 14.7314 21.9782 40.7628 -14.3918 6.6959 -6.38566 +3543 6 37.0263 36.0654 5.67599 -8.66989 11.0394 5.08886 +3544 4 36.7926 36.9074 5.26668 1.42879 3.21556 -9.50708 +3545 4 36.6993 36.1724 6.58455 6.67811 -8.44617 -2.15326 +3546 6 39.6264 22.8802 0.345968 -6.61229 0.0560669 1.87747 +3547 4 39.9979 23.7083 41.9266 1.97423 1.58642 1.0556 +3548 4 39.8106 22.8717 1.30105 -0.716498 -2.72173 1.5866 +3549 6 18.4762 23.1875 5.24196 -3.43754 -16.0644 -0.1002 +3550 4 18.2109 24.0785 4.97873 9.26343 12.8459 2.1419 +3551 4 19.3202 23.1705 5.73113 -5.23082 11.7415 -3.58503 +3552 6 34.4866 26.3931 0.410981 -26.1443 -19.9516 50.1306 +3553 4 33.9706 27.0567 0.94736 13.8106 -10.3269 -20.7381 +3554 4 34.4077 25.5868 1.01915 10.7474 25.1704 -28.4611 +3555 6 28.1474 26.0925 40.6196 -28.5345 -18.6936 36.4955 +3556 4 29.0529 26.0026 40.9247 9.18224 2.32741 -2.79367 +3557 4 27.6107 25.644 41.3519 15.6172 17.8969 -31.6189 +3558 6 41.7482 4.39863 30.2421 -5.41295 4.8086 27.4354 +3559 4 42.5847 3.93131 30.2216 8.80522 -6.59194 -7.61494 +3560 4 41.6924 4.68152 31.1831 -5.94926 -0.146025 -12.4776 +3561 6 4.45598 8.30655 29.1222 20.5127 -16.5965 8.52389 +3562 4 3.66946 8.7156 28.7677 -9.60933 13.4518 -0.978151 +3563 4 4.96147 8.97819 29.6123 -10.8114 0.933443 -7.64816 +3564 6 12.9096 9.61234 32.1411 7.95239 -11.3181 7.67023 +3565 4 12.5174 8.82681 31.7782 -9.40951 -4.97415 -8.25208 +3566 4 13.381 9.26623 32.9076 3.83436 11.6436 3.42456 +3567 6 48.6608 16.2478 1.44826 -41.5847 5.12436 -2.24268 +3568 4 49.5977 16.2655 1.51923 27.6715 2.95254 13.2549 +3569 4 48.2356 16.5221 2.2956 18.9339 -8.30142 -14.6437 +3570 6 26.4307 40.0076 21.1903 -9.81311 41.2665 6.04236 +3571 4 27.1749 40.6498 21.1967 -8.04845 -12.0635 0.822588 +3572 4 26.7755 39.1508 21.0026 13.0624 -20.4442 -2.17563 +3573 6 35.79 4.08177 9.00682 -31.6066 0.334495 -4.41207 +3574 4 35.483 4.74976 8.36033 1.0784 -4.66377 5.72074 +3575 4 35.0087 3.86601 9.59196 22.2264 5.21899 -16.6494 +3576 6 52.6895 3.55332 27.8634 16.2443 -8.90238 -17.7273 +3577 4 53.4861 3.5089 28.4695 -19.2533 -5.0216 -23.8454 +3578 4 52.9436 3.34738 26.8904 -3.28408 11.0051 45.9059 +3579 6 48.3169 26.6974 27.3926 25.9077 -23.6746 5.28014 +3580 4 49.0048 25.9927 27.5456 -25.7263 19.495 -6.18754 +3581 4 48.6886 27.4598 27.8411 -2.12981 11.4596 4.51315 +3582 6 24.5097 4.95686 18.7286 -11.1396 -9.34012 13.2359 +3583 4 24.0942 4.18073 19.1756 8.31772 16.1923 -9.35863 +3584 4 23.9484 5.73893 18.8892 6.66511 -10.1227 -0.689949 +3585 6 24.0567 12.4804 28.7686 -1.83015 0.889486 -1.95598 +3586 4 23.1997 12.8888 28.9043 -2.54864 9.49841 4.61676 +3587 4 23.8244 11.6446 28.3683 7.90245 -6.62953 -5.67748 +3588 6 40.1561 27.7426 40.8073 -21.5317 7.14576 -7.35733 +3589 4 40.4932 26.962 41.2601 -12.917 0.0491148 -0.726507 +3590 4 39.1936 27.5721 40.6401 25.9681 1.33069 1.19471 +3591 6 11.9274 13.5458 26.9496 -4.40765 -1.96337 -6.60028 +3592 4 10.9986 13.6678 27.167 -4.51497 -1.32563 0.190923 +3593 4 12.2404 12.8654 27.5442 6.31176 -11.0874 3.59056 +3594 6 52.1902 29.5387 41.394 18.594 -11.3781 3.59259 +3595 4 51.989 30.3087 0.0068425 -9.85392 15.5397 4.91192 +3596 4 53.1003 29.3208 41.6912 -5.64389 -6.04423 -8.59676 +3597 6 17.4867 19.0227 39.1838 -6.27455 21.666 2.75279 +3598 4 17.488 19.586 40.0024 0.860103 -14.9947 -21.9977 +3599 4 17.2876 19.5951 38.4014 5.36511 -12.0476 21.2649 +3600 6 46.2283 27.6807 33.7144 -6.74129 13.676 11.5468 +3601 4 46.0876 28.3582 33.0447 4.86435 -1.49715 -10.0026 +3602 4 45.6533 27.9743 34.4365 0.457797 -3.70748 6.99028 +3603 6 35.8353 29.5439 5.61992 2.49906 -1.59566 -19.7219 +3604 4 35.6527 29.5233 4.66367 4.90114 -0.621078 3.19465 +3605 4 35.4473 30.3766 5.88547 -3.82587 11.7884 10.6864 +3606 6 47.2822 25.7798 30.1513 -10.5766 8.53329 -17.9568 +3607 4 48.1664 25.813 29.7363 -13.2628 3.84456 1.19765 +3608 4 46.6616 26.387 29.6551 21.0058 -12.1546 6.47151 +3609 6 51.3953 12.3638 20.0228 -1.62023 8.46277 -4.73872 +3610 4 50.7529 12.7462 19.4094 4.65296 3.97806 -1.37635 +3611 4 50.8736 11.6867 20.4477 2.10356 -10.8225 11.04 +3612 6 41.9857 18.3757 28.9464 12.9674 -8.39178 -20.9845 +3613 4 42.6678 18.0249 28.3214 -8.5661 8.58724 12.8041 +3614 4 42.4509 18.9846 29.5329 1.95722 -2.13958 -2.01301 +3615 6 53.5955 6.47736 7.49747 -17.4879 -34.0434 -11.6994 +3616 4 53.215 5.56736 7.34717 12.2612 27.0176 1.32153 +3617 4 53.8473 6.47025 8.42428 8.27981 0.813073 3.28926 +3618 6 9.90701 10.6092 26.7593 2.25524 -7.80823 -0.160956 +3619 4 10.2937 10.2906 27.6083 -8.74192 13.2514 -11.8083 +3620 4 9.6719 11.5504 26.8324 5.3909 -8.28719 7.73453 +3621 6 9.32838 39.4044 29.7661 28.1478 19.087 17.9947 +3622 4 10.1636 39.3682 30.3277 -29.6144 2.71186 -18.0569 +3623 4 8.79772 40.1574 30.1092 9.7156 -13.1012 -9.05156 +3624 6 33.3969 4.77935 0.0338577 7.04977 -8.48101 -1.75146 +3625 4 33.7652 5.5373 41.4968 -3.54645 16.0087 -2.35532 +3626 4 34.1271 4.15493 41.8774 -6.76144 -3.49152 6.70786 +3627 6 35.7118 10.6691 34.2465 30.5451 -20.2214 -10.6481 +3628 4 35.199 10.7815 35.0349 -14.696 6.44481 20.012 +3629 4 36.4515 10.0721 34.5187 -16.7263 14.6249 -6.06398 +3630 6 15.1941 17.3851 19.1797 2.70911 -28.1342 -44 +3631 4 15.4897 16.9339 18.3047 -12.3876 19.7973 41.7399 +3632 4 14.2542 17.5546 19.0074 0.407714 2.19657 2.29796 +3633 6 17.478 37.6645 15.4329 -18.9254 1.45878 17.8737 +3634 4 16.9549 37.8023 16.2867 26.4617 -7.60783 -22.0624 +3635 4 18.4074 37.4659 15.6333 -6.79317 3.25497 7.31584 +3636 6 26.2497 8.20945 21.7084 13.406 8.66037 11.1677 +3637 4 26.4123 8.51714 22.643 -13.4745 -7.28424 -22.9055 +3638 4 25.3027 8.1176 21.5293 -5.49097 3.27453 10.4234 +3639 6 0.34 9.90937 15.4047 -28.932 15.8312 -5.67551 +3640 4 1.21626 9.57115 15.2747 8.47529 -16.8828 -5.88536 +3641 4 54.6903 9.41637 14.8207 22.8064 6.49071 10.4803 +3642 6 13.4564 40.6532 9.29599 -22.1307 -5.15585 -0.326819 +3643 4 12.4714 40.4452 9.30279 34.033 7.20134 3.90171 +3644 4 13.9359 39.9749 9.79874 -9.44555 -0.536228 -2.64909 +3645 6 49.5525 25.9167 33.0087 8.30289 -20.978 36.7812 +3646 4 50.1102 25.581 33.7998 -31.2394 16.5759 -41.6702 +3647 4 48.6381 25.5592 33.0807 18.1841 3.33668 -0.378289 +3648 6 37.0921 40.0433 26.4323 -69.9693 32.9093 31.9949 +3649 4 36.1848 39.6472 26.7001 50.2617 0.87061 -16.3943 +3650 4 36.887 40.9984 26.66 23.4133 -30.5831 -16.8038 +3651 6 47.9876 17.8592 12.1588 -8.21233 14.3088 -32.1086 +3652 4 47.5845 18.6288 11.6747 8.44083 -19.6159 16.8154 +3653 4 47.7143 17.8826 13.0665 -7.39134 3.08395 19.3289 +3654 6 27.9663 29.0642 34.1603 1.53587 -18.0299 -1.74725 +3655 4 28.882 28.804 34.3498 -7.37789 1.41773 -2.30399 +3656 4 27.9529 30.0159 34.1809 1.22694 21.8088 1.61581 +3657 6 34.0029 2.78452 13.2168 -24.1529 16.185 8.10865 +3658 4 33.6393 2.32953 13.9926 -4.91269 2.52718 -2.68734 +3659 4 34.7844 2.29731 13.0428 30.2788 -14.7346 -8.06408 +3660 6 28.44 36.053 11.4482 -19.9886 -0.916941 20.5685 +3661 4 28.0041 35.3416 10.9605 0.296796 1.69001 -2.92558 +3662 4 29.0597 36.4216 10.8465 18.9417 8.99323 -20.1084 +3663 6 36.1834 11.364 28.8528 2.80179 -1.8504 -16.6465 +3664 4 35.2026 11.3648 28.9433 17.0081 -1.44193 -10.527 +3665 4 36.4266 11.2403 27.8881 -16.5332 2.0664 24.3605 +3666 6 24.8155 39.488 16.899 1.95651 8.69094 -17.2938 +3667 4 24.2729 40.277 17.0547 2.68209 -2.76325 7.28198 +3668 4 24.7648 39.3887 15.9322 -0.898649 -0.731043 6.96785 +3669 6 49.9432 8.0514 22.8505 -60.8038 -24.1516 -13.0827 +3670 4 49.7668 7.94962 23.7845 10.2147 3.57848 16.1239 +3671 4 49.0378 7.75433 22.5026 41.2245 11.1916 1.13457 +3672 6 52.0935 19.338 10.2277 12.6357 -4.19253 18.0692 +3673 4 51.6063 19.2592 9.39778 1.74616 10.4418 -3.52762 +3674 4 52.4735 20.2434 10.294 -12.5007 -15.5081 -12.5544 +3675 6 24.8386 15.8838 6.12895 -18.3448 14.0073 -0.236232 +3676 4 24.2024 16.3229 6.74681 14.2411 -11.6767 -8.77744 +3677 4 24.4989 16.1625 5.25788 7.11766 -3.93298 6.13727 +3678 6 49.3148 23.6851 8.6303 24.9689 -39.379 16.691 +3679 4 49.2746 22.9584 9.31909 -7.63259 29.9964 -23.4819 +3680 4 48.4638 24.0489 8.3953 -15.5352 0.433996 3.53825 +3681 6 0.208059 10.6481 32.1797 22.1875 -2.28391 4.69689 +3682 4 1.08388 10.2912 32.3483 11.827 -2.86298 -20.6213 +3683 4 54.878 10.581 33.0649 -30.4469 3.74284 18.7822 +3684 6 12.5874 32.9143 13.2407 -35.4131 4.94433 4.95913 +3685 4 11.7345 33.4182 13.1185 22.1299 -14.9844 2.19911 +3686 4 13.2795 33.4792 12.9271 13.1216 10.0242 -5.44208 +3687 6 21.734 32.5657 14.1089 -30.2641 -10.609 17.8788 +3688 4 21.1735 33.3586 14.1938 13.4775 0.171544 -7.80997 +3689 4 21.2373 31.9121 14.6504 18.4585 12.3126 -12.4653 +3690 6 48.1656 34.8484 27.3207 -34.4178 -12.3509 -32.6658 +3691 4 47.5287 35.1179 27.9926 9.598 2.53078 9.45385 +3692 4 47.5616 34.4813 26.6056 29.2581 12.2879 19.461 +3693 6 45.6153 31.2627 36.0943 -37.261 16.4569 21.0579 +3694 4 45.7916 31.8927 35.3904 -0.807743 4.61331 -8.81752 +3695 4 44.8366 31.6277 36.6156 19.759 -7.25665 -17.1647 +3696 6 46.2873 0.296503 14.3622 0.346279 -8.22198 0.0964187 +3697 4 46.2502 1.23933 14.2464 -13.6881 13.1616 4.37405 +3698 4 47.2018 42.0236 14.1712 14.709 -12.2876 -2.23521 +3699 6 14.3299 18.994 40.2006 -30.7379 -32.6603 -9.06287 +3700 4 14.4791 19.2338 39.2972 7.93482 8.11578 -14.4624 +3701 4 14.6855 19.6458 40.7662 17.9566 28.0241 18.1173 +3702 6 14.5596 1.14026 10.2341 26.3279 -2.23148 -9.5451 +3703 4 15.4055 1.22344 9.73443 -17.3894 7.51472 10.761 +3704 4 14.1379 0.381418 9.8097 -7.55267 -3.97863 3.86231 +3705 6 34.4334 40.9199 12.9894 -0.940803 4.29697 -17.7271 +3706 4 34.039 40.5607 12.1545 5.82782 2.6847 22.9711 +3707 4 34.273 40.3011 13.7266 -2.01031 0.481385 -16.696 +3708 6 42.1477 25.6267 33.9881 24.0417 -24.4569 -2.75436 +3709 4 41.6299 25.3559 33.2134 -0.0206438 0.202706 6.41118 +3710 4 42.855 24.9213 34.0976 -22.0628 21.5276 -5.85955 +3711 6 29.1852 22.5895 40.0737 -4.6165 -6.65381 -10.571 +3712 4 28.5947 23.1672 39.581 -0.582997 4.41945 3.85107 +3713 4 29.0675 22.7332 41.0074 -2.93269 3.94269 10.2267 +3714 6 44.8062 18.6252 1.49818 5.72139 3.58279 15.6322 +3715 4 44.9314 18.8801 2.44529 -3.9019 -2.65234 -18.9387 +3716 4 44.0985 19.1782 1.14518 3.29812 2.13948 3.69359 +3717 6 4.47265 10.8135 23.9407 -24.2902 -18.4562 11.3409 +3718 4 5.11906 11.4142 23.6391 22.3407 21.5355 -19.7447 +3719 4 4.51291 10.8829 24.8932 -6.80118 0.381125 6.4492 +3720 6 6.46087 23.0097 28.9948 -0.180046 29.3158 3.74757 +3721 4 7.16357 23.1777 29.6697 -12.977 -15.1924 -17.9731 +3722 4 6.42476 22.0762 28.8013 7.623 -17.0728 6.50296 +3723 6 39.796 25.1427 32.5747 9.70804 -1.04373 -32.2987 +3724 4 39.5377 25.4516 33.4106 -12.9416 11.3784 38.6909 +3725 4 39.6539 25.9218 32.0211 1.09764 -5.16827 -8.54386 +3726 6 40.8629 21.4836 8.86543 0.741147 13.6451 -7.24725 +3727 4 40.6441 21.3431 7.92826 2.29745 -6.5969 8.98303 +3728 4 41.3236 20.7041 9.20266 3.81714 -8.25026 -3.81722 +3729 6 0.635293 1.4289 12.9408 -11.8573 10.3167 -17.0811 +3730 4 54.7874 1.76314 12.6159 9.08744 8.74788 -10.2417 +3731 4 0.270536 0.805051 13.547 10.8795 -21.9384 23.5147 +3732 6 32.6734 29.7199 23.4842 -6.31159 -22.9731 3.95312 +3733 4 32.3164 28.805 23.472 7.37478 14.3791 4.20759 +3734 4 32.5291 29.9779 22.5736 0.738758 10.2783 -10.1223 +3735 6 12.5322 37.1564 20.4866 30.6876 51.3804 29.6269 +3736 4 13.0449 37.1468 21.3313 -10.4644 -1.04639 -16.0138 +3737 4 12.1935 36.3015 20.3752 -17.5174 -49.5479 -6.43685 +3738 6 13.879 14.5208 24.6979 -2.0089 -0.488943 14.0828 +3739 4 13.5126 15.2415 24.1863 -2.86121 7.01781 -5.24136 +3740 4 14.0435 14.8889 25.5812 -0.885703 0.504049 -6.33424 +3741 6 17.5084 27.0547 26.4789 25.7109 3.2743 -38.4356 +3742 4 17.3703 27.9297 26.0618 -4.07905 -12.769 13.7294 +3743 4 18.1097 26.6273 25.8042 -17.4354 5.34049 24.3014 +3744 6 54.4807 9.52867 26.3526 -8.08409 11.5192 21.059 +3745 4 54.0543 10.3952 26.5681 7.59002 -15.9534 -5.94965 +3746 4 54.8701 9.18952 27.1901 -5.85154 7.09102 -14.0848 +3747 6 33.6811 21.5047 24.9231 9.13792 -2.03882 -43.3211 +3748 4 33.6373 21.3676 23.9235 3.71376 4.25849 32.7793 +3749 4 32.846 21.1613 25.2346 -13.4677 -6.75943 10.2286 +3750 6 22.147 35.267 2.89295 -1.50127 3.24452 17.3348 +3751 4 22.2381 34.4 2.47628 0.948748 -2.82555 0.0189077 +3752 4 22.0999 35.1233 3.8735 0.523717 -2.91888 -18.7193 +3753 6 45.3111 5.3951 15.6139 -0.0233827 -18.9082 29.3701 +3754 4 45.1442 5.22798 16.5663 9.63366 2.6406 -14.7931 +3755 4 44.5125 5.84005 15.3428 -8.81534 4.22624 -14.6387 +3756 6 5.67663 7.59044 16.9735 -0.040306 4.08799 -12.5895 +3757 4 5.28026 7.88599 16.128 7.47401 -1.2917 10.5251 +3758 4 6.58383 7.937 17.01 -0.793937 -3.87211 -2.68331 +3759 6 34.58 39.0977 27.2045 1.42769 14.436 -3.31523 +3760 4 34.2907 38.4975 27.863 -0.77861 -26.0942 16.6839 +3761 4 34.0642 39.8725 27.4397 -1.42861 13.6713 -5.6929 +3762 6 32.7657 33.6085 34.293 -22.4583 20.5671 -18.6673 +3763 4 32.1806 34.0441 33.6111 23.9751 -17.2665 15.818 +3764 4 32.4638 34.0082 35.1245 2.30326 -6.42306 -1.86009 +3765 6 30.988 41.2133 32.384 -4.02481 -7.82035 -3.95856 +3766 4 30.2267 41.2202 32.9774 -4.32902 6.50081 -0.328838 +3767 4 31.0509 0.17511 32 -1.2051 10.1503 -2.92525 +3768 6 7.6493 1.59177 27.1464 22.3535 -22.6118 -16.4669 +3769 4 8.41104 1.29664 26.5499 -29.8997 15.2665 16.3611 +3770 4 7.54328 2.53873 27.061 4.65755 9.49162 -4.22239 +3771 6 0.888965 22.101 37.8501 15.4112 -23.8094 -16.9331 +3772 4 1.26739 21.3109 37.3638 -11.0686 24.0488 15.8162 +3773 4 1.18 22.8712 37.3372 -1.61814 -2.27923 2.93708 +3774 6 7.39632 11.121 19.2332 -2.86932 4.41375 3.62624 +3775 4 7.58751 12.0436 19.3904 -7.23274 18.3647 6.41875 +3776 4 8.29083 10.7877 19.1848 5.97481 -12.1861 -3.76707 +3777 6 43.7816 12.5054 37.3126 2.86093 2.78929 -1.28281 +3778 4 43.9727 12.4749 36.3586 -3.06612 0.785718 5.83621 +3779 4 44.6572 12.6706 37.7021 -4.14278 -2.20963 -1.61523 +3780 6 29.0947 33.5132 36.1777 7.61955 17.1376 -26.1106 +3781 4 29.8261 34.0815 35.8667 -13.5031 -6.20718 4.51186 +3782 4 29.4784 33.1216 36.9462 10.9925 -12.9866 20.6523 +3783 6 14.807 4.60084 3.93512 20.0881 9.19657 -13.3363 +3784 4 14.316 4.04064 3.33426 -13.0632 -7.60853 1.79497 +3785 4 15.6236 4.79338 3.42413 -10.111 -0.253003 10.8348 +3786 6 39.0437 6.41097 6.40143 -11.952 4.4329 11.9095 +3787 4 39.4604 7.16771 6.02322 8.12547 27.0605 -0.357881 +3788 4 39.3566 5.75952 5.7919 -0.567413 -21.3616 -5.48613 +3789 6 22.2146 37.9992 40.767 -9.02066 -17.4896 -19.1754 +3790 4 22.494 38.8839 40.5618 6.85259 22.4587 -5.93601 +3791 4 22.4583 37.8811 41.6743 4.99519 -4.33654 23.0463 +3792 6 4.4524 23.286 6.15211 29.8095 -7.21279 -13.1375 +3793 4 3.81791 23.938 6.45512 -14.4589 -6.71938 9.72163 +3794 4 4.31449 22.3781 6.49744 -8.68344 13.1635 4.00749 +3795 6 12.4271 23.7748 9.24631 -1.26755 4.43152 21.3749 +3796 4 11.5607 23.6235 8.88266 -11.7175 -2.77193 -9.11925 +3797 4 12.2509 24.3149 10.0432 11.3809 -1.60307 -13.9136 +3798 6 46.4989 15.2625 16.9679 -12.8481 -2.49131 10.8408 +3799 4 47.085 14.9252 16.2779 8.49272 6.07271 -3.86524 +3800 4 46.8927 16.0486 17.3753 9.61298 -1.72862 -3.23202 +3801 6 34.1182 27.164 19.7815 17.9289 -11.392 6.58771 +3802 4 34.8637 26.5005 19.7508 -17.7467 14.3364 5.12367 +3803 4 34.0077 27.4664 20.702 3.31322 -6.80894 -12.4792 +3804 6 46.9518 13.2225 35.1059 11.5726 -0.299351 34.0182 +3805 4 47.3951 14.0533 34.9197 -1.30218 2.22738 -12.772 +3806 4 46.5273 12.8898 34.3328 -6.46075 0.0352155 -21.0879 +3807 6 50.5846 18.7905 12.5321 0.161349 -2.47544 -10.5355 +3808 4 49.7474 18.3698 12.2516 10.3296 3.30344 0.704295 +3809 4 51.1853 18.7954 11.7538 -11.6392 0.795373 7.80699 +3810 6 32.4849 12.6316 31.9547 13.623 -32.1984 -17.1952 +3811 4 32.7548 11.6805 31.9646 -3.77817 17.5545 -6.43374 +3812 4 32.3724 12.7906 32.8759 -7.39939 11.2146 27.5789 +3813 6 6.21204 19.6856 10.0139 6.84548 18.8235 13.1049 +3814 4 6.54027 20.2383 9.28123 0.761161 -1.37122 2.72757 +3815 4 6.08461 20.3138 10.7689 1.69871 -13.3343 -16.4193 +3816 6 21.5267 21.5372 2.4283 -5.72751 11.2346 -5.82425 +3817 4 21.7624 21.5115 1.48057 4.80944 -6.6677 9.03128 +3818 4 21.9699 20.8013 2.88237 1.68469 2.19074 -10.3234 +3819 6 38.389 23.0803 17.19 -15.8009 11.2489 14.8144 +3820 4 38.843 23.3405 16.3672 7.30113 -17.2523 7.40945 +3821 4 38.5581 22.1678 17.4979 8.57434 6.38113 -15.3203 +3822 6 29.7009 24.9705 22.2505 40.9979 -45.9373 -29.6811 +3823 4 30.2007 24.9541 23.0531 3.51493 7.58579 28.6285 +3824 4 28.9709 25.5198 22.3387 -45.941 40.092 17.1582 +3825 6 30.3026 21.4444 37.7784 -57.0222 17.1687 -23.3742 +3826 4 30.3615 21.3347 36.805 9.38026 -2.23221 21.4717 +3827 4 29.3011 21.6413 37.9016 49.3444 -12.8915 1.59191 +3828 6 11.8723 11.7062 16.3108 -33.4349 -15.0686 -41.1118 +3829 4 11.3207 12.2631 16.8681 -3.98396 2.02201 -1.40695 +3830 4 11.3108 11.5232 15.4705 24.8968 9.48818 41.0096 +3831 6 5.70652 16.9717 10.4705 4.17204 -12.2255 5.26049 +3832 4 4.89872 17.0293 11.0039 1.44556 1.21447 -8.81597 +3833 4 5.85075 17.8293 10.0626 -3.65007 4.58518 2.58079 +3834 6 41.6977 34.1692 35.8837 -2.16171 7.35997 35.3278 +3835 4 41.9434 35.0359 36.2767 -7.39108 -12.3774 -11.2945 +3836 4 41.6554 34.2509 34.9408 0.248654 6.88642 -24.6778 +3837 6 33.755 1.15956 30.1148 26.9661 -5.30311 0.785489 +3838 4 32.8327 1.41064 30.2749 5.35845 -2.81639 19.5818 +3839 4 34.3082 0.981132 30.9387 -30.8845 7.54253 -18.2089 +3840 6 50.3537 18.6141 36.9811 22.0078 18.2711 -1.17075 +3841 4 50.0553 18.9081 37.8421 -3.0234 4.11827 7.26126 +3842 4 49.7241 17.9789 36.6994 -26.7065 -28.1871 -12.5747 +3843 6 24.6713 24.2747 40.2422 -22.5478 13.5437 8.83718 +3844 4 23.7682 24.4281 40.6159 16.469 -5.34198 -8.29501 +3845 4 24.8078 23.3187 40.2616 -1.76472 2.5507 -0.358513 +3846 6 37.3089 22.0315 23.2412 -5.67505 16.6134 8.34505 +3847 4 36.9227 21.8066 24.1113 8.4343 -8.15598 -10.5545 +3848 4 37.8295 21.3076 22.8826 1.63944 -5.88141 4.04288 +3849 6 48.4175 40.505 28.9613 -8.44239 17.3351 -31.8351 +3850 4 48.9168 41.2502 28.5701 -3.67522 -6.90368 3.5913 +3851 4 47.6498 40.4225 28.3398 9.75729 -4.39015 14.633 +3852 6 24.8456 8.73476 16.5822 -4.20971 0.107082 12.7896 +3853 4 25.4166 9.33437 17.0882 0.801486 -3.84637 -6.6671 +3854 4 25.3552 7.93888 16.3774 1.47583 -1.66023 -1.71228 +3855 6 19.2415 22.9983 32.4591 18.0731 -7.21062 -7.32059 +3856 4 18.4972 23.4837 32.0941 -3.55414 -1.2008 3.19393 +3857 4 18.9283 22.447 33.1757 -6.31405 0.951806 3.86493 +3858 6 3.33315 21.6719 22.4471 -31.3651 -15.1442 10.7623 +3859 4 2.72119 22.0562 23.134 20.4737 -7.45649 -18.1084 +3860 4 4.09369 22.238 22.38 14.9219 12.7334 2.89238 +3861 6 10.2287 20.327 12.827 -13.2346 -13.5387 -5.73443 +3862 4 9.59835 20.9044 13.2794 3.30523 -1.6991 -3.3419 +3863 4 9.66163 19.6709 12.3619 8.96671 11.3846 7.22783 +3864 6 9.52445 0.665703 25.3447 51.6699 36.9138 -22.1471 +3865 4 10.407 0.70007 25.8038 -28.3091 -11.588 2.11711 +3866 4 9.73816 1.30323 24.5834 -23.5062 -26.9191 23.3279 +3867 6 10.6629 40.7098 9.64162 -13.7092 -10.0604 -17.7529 +3868 4 10.6663 41.3337 10.3633 -2.25222 9.44489 9.13119 +3869 4 9.9177 40.9644 9.04966 14.1089 -1.91013 12.7496 +3870 6 46.3583 25.2138 32.6818 -7.00173 28.401 24.5039 +3871 4 46.1658 26.0815 33.1748 9.63216 -40.3762 -24.4036 +3872 4 46.6683 25.4845 31.8081 -0.340565 -0.626762 -0.366217 +3873 6 38.9398 3.19835 23.1062 35.7507 -3.98021 4.80576 +3874 4 38.0789 3.42388 22.7807 -21.691 0.0477325 0.592254 +3875 4 38.9606 2.6551 23.9199 -14.9585 3.95725 -7.0779 +3876 6 33.3518 23.6324 36.8776 -10.909 11.1506 22.2396 +3877 4 32.7475 23.7189 37.6717 16.9933 -10.7727 -23.1962 +3878 4 33.5054 24.5617 36.6454 5.48307 -3.56245 -8.14833 +3879 6 51.9403 33.327 25.4307 18.0164 46.0043 -41.5452 +3880 4 51.481 33.1217 26.2288 -14.6019 -1.8433 25.1586 +3881 4 51.8744 34.3335 25.2555 2.07578 -44.1738 12.4077 +3882 6 32.1773 25.016 33.1611 -3.65323 12.5958 -4.40686 +3883 4 32.7417 25.8243 33.1248 -13.2213 -13.5953 2.20315 +3884 4 31.2567 25.3353 32.9959 15.6883 -4.24783 1.324 +3885 6 51.2804 27.7082 39.5058 -12.4055 -13.8576 13.4454 +3886 4 51.6333 27.8214 38.6405 7.56348 -1.28822 -27.9214 +3887 4 51.668 28.4332 39.9759 4.38661 13.1583 16.7532 +3888 6 34.2776 28.325 17.2612 18.5433 -9.6807 0.726105 +3889 4 33.4618 28.7621 17.0499 -21.6526 10.7978 2.5619 +3890 4 34.2928 28.1986 18.2187 -4.64072 -2.98555 4.57564 +3891 6 36.914 8.0422 37.8636 -11.4128 -16.3489 28.1347 +3892 4 37.1972 8.46051 37.0352 12.2245 9.0272 12.2411 +3893 4 37.2151 8.41454 38.7513 -7.64029 -1.69915 -40.4466 +3894 6 34.8876 19.4054 6.12727 15.6033 7.52257 2.15709 +3895 4 34.0531 18.9355 6.15655 -6.74313 -1.04378 -1.75599 +3896 4 34.6977 20.3552 6.00766 0.606543 -4.24654 -1.2187 +3897 6 52.9513 9.46866 7.83406 2.51792 52.5995 -46.1577 +3898 4 52.8182 10.1965 7.1313 21.8169 -33.4663 26.408 +3899 4 52.1097 9.49548 8.25498 -20.9439 -11.3984 23.93 +3900 6 36.2784 5.48477 38.9735 -18.6298 -4.41122 2.56352 +3901 4 36.9459 5.47799 39.6359 15.3203 -14.8264 18.8091 +3902 4 36.5882 6.23606 38.5023 -2.18903 24.2959 -30.3279 +3903 6 10.0091 14.4595 13.4727 4.14065 20.8003 14.1725 +3904 4 10.1735 15.3719 13.8184 -7.35802 -17.2864 -8.75733 +3905 4 9.20522 14.5177 12.9398 -1.57173 0.82324 -0.279823 +3906 6 17.2166 24.3595 39.7866 10.3316 -24.6644 9.74438 +3907 4 16.8461 25.2181 39.6219 -11.8102 15.8188 2.99696 +3908 4 16.9967 24.0978 40.7081 2.51259 6.67153 -9.86646 +3909 6 49.0842 32.5535 7.76087 3.66191 -12.3496 8.85055 +3910 4 48.2705 33.0417 7.89853 -4.87459 2.09702 3.01394 +3911 4 49.5463 32.9698 7.04629 8.35168 7.01386 -14.6239 +3912 6 44.8849 24.3899 5.46806 25.9844 8.68062 13.8603 +3913 4 44.662 24.5947 6.37974 6.74107 7.22813 10.7323 +3914 4 44.0754 24.0079 5.20592 -32.7636 -20.0017 -25.3594 +3915 6 37.3054 29.188 32.8461 11.1431 -5.59449 16.1726 +3916 4 36.8523 29.4202 33.6742 6.83247 1.44061 -4.51415 +3917 4 36.6742 29.3068 32.1579 -22.7291 3.94299 -14.9304 +3918 6 0.907991 24.8221 21.2346 15.0832 19.7352 -4.57067 +3919 4 1.06453 25.2816 20.3717 -1.39622 -8.03116 21.3543 +3920 4 1.45755 25.2897 21.9154 -11.7661 -11.1398 -13.6241 +3921 6 53.0192 2.206 13.0014 -0.818186 11.5483 2.08343 +3922 4 52.7824 1.81345 13.8314 -6.90556 -15.4066 8.50991 +3923 4 53.4537 3.0128 13.31 2.83183 5.68595 -7.528 +3924 6 24.3052 33.9756 13.9324 20.4312 -11.5489 10.0229 +3925 4 23.7773 33.1726 14.1229 5.8111 10.1191 -2.33499 +3926 4 25.2169 33.8698 14.327 -30.0349 3.28274 -10.0023 +3927 6 40.9302 19.2912 0.318024 -15.3988 27.4065 1.86032 +3928 4 41.1581 18.3902 0.297675 9.36546 -44.4479 -0.119704 +3929 4 41.7646 19.7516 0.396104 7.20249 9.57203 1.55489 +3930 6 38.311 32.026 21.5914 -16.5672 24.1097 -12.7773 +3931 4 37.7777 31.3762 21.1012 4.07846 0.69211 1.97712 +3932 4 37.9765 32.9287 21.3171 8.34414 -28.994 10.9395 +3933 6 42.3062 34.9979 16.9676 -25.16 18.3345 5.87282 +3934 4 41.5364 35.0784 17.5803 19.0968 -0.611651 -8.13832 +3935 4 42.7061 34.1505 17.1117 7.13758 -14.417 1.0169 +3936 6 19.559 24.3289 21.9471 -10.3882 -39.985 28.3228 +3937 4 19.0651 23.5074 22.2416 22.0177 25.9498 -5.97634 +3938 4 18.911 24.732 21.3859 -10.0006 10.9377 -12.5795 +3939 6 21.0734 3.08215 14.9508 5.66735 1.93263 4.27485 +3940 4 21.953 3.50152 15.1067 -15.9394 -6.36392 -7.95302 +3941 4 20.9814 2.87634 14.0019 2.73511 2.88399 3.27523 +3942 6 16.4416 12.1461 28.5328 0.855962 3.79198 1.54672 +3943 4 16.9672 12.6551 29.168 -2.37031 -0.949071 -4.41291 +3944 4 15.802 12.7688 28.1665 0.405815 -3.95107 1.98596 +3945 6 29.5641 4.71626 21.7415 17.492 -20.3905 -14.0863 +3946 4 29.717 3.79719 21.4198 0.937107 17.7735 8.56359 +3947 4 28.6765 4.939 21.4721 -9.06619 5.19467 -0.439365 +3948 6 47.4133 12.088 13.4013 -19.6032 -12.6622 16.1152 +3949 4 46.7677 12.2286 12.6843 7.8139 0.82382 7.69043 +3950 4 46.8958 11.6888 14.1608 19.5987 16.3505 -27.3211 +3951 6 26.4348 0.0314913 5.59163 -38.6673 11.9556 1.59378 +3952 4 25.5144 0.513751 5.59151 44.3701 -31.5426 2.21012 +3953 4 26.2832 40.9933 5.84663 -4.6239 23.4679 -5.56234 +3954 6 20.8211 34.8097 41.3598 6.97593 19.5597 16.9804 +3955 4 20.8796 35.753 41.6458 -3.00787 -20.9192 -8.75426 +3956 4 21.5767 34.358 41.784 -4.89338 4.10004 -2.4608 +3957 6 12.6876 17.479 1.38718 -1.79098 16.5747 12.6529 +3958 4 12.721 17.2085 2.3151 1.79447 -6.15344 -4.56661 +3959 4 12.6249 16.7029 0.834077 -0.882684 -12.7315 -6.97767 +3960 6 30.0809 10.1879 8.41184 2.17826 -2.71045 -21.4672 +3961 4 29.3744 10.7602 8.07412 2.70218 -2.7161 1.39802 +3962 4 29.921 10.0821 9.33998 -2.4398 0.0699553 19.6849 +3963 6 36.338 5.45526 23.9203 5.99313 10.0946 16.1749 +3964 4 36.1182 6.35936 23.6236 3.48165 -5.42435 1.21963 +3965 4 37.0503 5.55216 24.5976 -11.7354 -2.45534 -11.6386 +3966 6 34.0137 39.9398 19.5054 17.9066 -9.75089 21.0607 +3967 4 34.5988 39.5452 20.1731 -15.7075 -1.02338 -1.83906 +3968 4 34.6431 40.5289 19.082 -7.6391 9.5881 -14.1485 +3969 6 25.1112 29.0201 17.0007 35.0878 36.529 -22.1514 +3970 4 24.4917 28.3695 17.2244 -30.3786 -36.8419 16.5077 +3971 4 24.8604 29.2867 16.1023 2.15056 -2.21883 6.37313 +3972 6 28.5036 21.3308 6.52422 21.0338 -5.55128 30.7615 +3973 4 28.0688 21.6386 5.71574 5.06238 16.4658 -0.926129 +3974 4 28.989 22.0506 7.05137 -24.5794 -13.751 -30.0602 +3975 6 18.6637 26.1498 0.432001 -8.53447 25.4727 10.2843 +3976 4 18.1393 25.3713 0.533905 -9.92127 -26.6833 -5.54807 +3977 4 18.1707 26.7698 1.00478 10.6071 3.27379 -7.60185 +3978 6 10.9817 29.7047 15.4617 -41.5317 11.7513 13.4553 +3979 4 11.6879 29.3608 14.9846 35.2501 -21.9962 -32.1318 +3980 4 11.3889 29.9926 16.2601 5.02956 8.45945 23.8164 +3981 6 33.4827 3.76017 10.5773 -2.41261 -0.304069 24.838 +3982 4 33.4731 3.39919 11.5182 2.46452 11.5285 -31.0446 +3983 4 33.5847 4.73535 10.6555 -0.240223 -15.9168 2.16837 +3984 6 12.2973 28.805 23.0387 -1.70787 -5.55619 5.61474 +3985 4 12.73 29.6571 22.9381 2.67417 5.94729 -0.690524 +3986 4 11.5024 28.994 23.5653 2.03311 -0.198261 -3.05575 +3987 6 13.0915 10.291 41.0216 -35.9662 5.53295 8.52282 +3988 4 13.8386 10.0408 41.5246 29.6538 -8.48465 17.7322 +3989 4 13.4107 10.5366 40.1733 8.17866 7.18603 -23.992 +3990 6 45.8162 29.981 22.3537 -23.4909 -34.782 -9.94688 +3991 4 46.3605 30.6906 22.6479 19.8522 18.211 11.3118 +3992 4 46.1638 29.1315 22.7274 -3.04842 19.9099 -5.39144 +3993 6 41.5671 12.1372 14.78 12.0724 6.03101 -10.0784 +3994 4 40.8481 12.1001 15.4119 -11.2612 -2.38036 6.73971 +3995 4 41.9114 13.0311 14.8874 5.93112 4.19505 -0.667369 +3996 6 18.1729 7.20363 24.1739 -28.0382 48.7978 3.52623 +3997 4 17.4064 7.85498 24.128 33.406 -18.9268 -1.93395 +3998 4 17.7199 6.38321 24.1568 -14.2968 -40.16 -0.285645 +3999 6 1.47767 28.308 7.57167 -25.5616 27.2209 -25.1393 +4000 4 0.827452 27.622 7.68711 2.49251 -16.9659 6.86802 +4001 4 0.906232 29.0217 7.18328 24.331 -5.18373 6.93061 +4002 6 11.3359 12.3164 24.0718 -23.8013 37.4997 -14.7667 +4003 4 11.6691 13.0224 24.6595 3.51665 -15.1291 3.43827 +4004 4 11.6925 11.4858 24.3227 20.8697 -21.176 20.4973 +4005 6 17.9852 40.4684 24.4198 -2.05389 -13.7174 33.2687 +4006 4 18.291 40.9889 23.6947 8.79563 24.1615 -11.819 +4007 4 17.8495 41.0209 25.2243 7.13458 -7.65509 -20.9696 +4008 6 25.5964 7.43792 34.0141 13.5012 12.0052 -20.5927 +4009 4 25.8913 7.969 33.2287 -3.90825 -14.1502 17.4414 +4010 4 24.6674 7.63663 34.1466 -9.57807 0.741149 3.27376 +4011 6 16.9692 36.3856 7.79034 -41.9934 -28.8773 9.66508 +4012 4 16.1027 35.9203 7.98218 37.4859 8.56847 -14.648 +4013 4 16.8197 37.2026 8.24874 12.7807 20.325 5.07796 +4014 6 12.4125 39.1679 36.8113 4.83627 -30.6012 -9.1357 +4015 4 13.2866 39.4994 36.9682 3.20673 22.8904 8.84646 +4016 4 12.7018 38.3069 36.4569 -23.4958 5.90479 1.90955 +4017 6 23.4443 1.91649 37.7131 1.30421 0.985484 -2.89526 +4018 4 22.7028 1.66545 37.1374 7.60384 11.2995 4.79583 +4019 4 23.7753 2.79308 37.4363 -6.35903 -5.24233 -3.11404 +4020 6 26.6169 34.8556 39.068 -18.8945 24.0174 -16.1573 +4021 4 25.9011 35.0209 39.7003 9.00825 -5.11239 -0.809586 +4022 4 26.448 35.531 38.356 7.64302 -20.2436 14.8851 +4023 6 44.7566 35.572 23.174 8.53117 -4.94531 -21.3447 +4024 4 44.5551 36.3183 23.7275 -7.66893 11.3086 12.1688 +4025 4 44.9082 35.9286 22.2729 -0.906387 -11.1819 10.3159 +4026 6 34.6091 35.4265 26.6991 -7.96701 8.74937 -1.29134 +4027 4 33.7558 35.2865 27.1578 16.0802 3.93421 -4.37465 +4028 4 35.2785 35.5457 27.4013 -9.86041 -2.80018 -4.60569 +4029 6 12.4308 29.8402 9.37325 4.00701 15.5633 13.1387 +4030 4 12.6298 30.2095 10.2592 0.427445 -8.8693 -11.9579 +4031 4 11.9163 30.5385 8.94302 -0.259504 -4.09781 -0.505047 +4032 6 46.4536 41.3715 16.9585 -0.509472 -10.7221 -3.48983 +4033 4 46.3968 0.20327 17.5639 0.209317 7.43894 6.10767 +4034 4 46.3711 41.769 16.0793 0.075994 -2.20044 0.741492 +4035 6 39.1811 31.047 24.0166 -28.3946 14.7902 -31.7872 +4036 4 39.0009 31.2944 23.0615 15.0891 -8.50563 28.3067 +4037 4 38.282 31.1199 24.3765 13.6746 -2.33731 7.34059 +4038 6 40.5375 9.75603 28.9763 9.47615 -22.8392 -16.3574 +4039 4 40.717 8.78834 28.9749 -4.02124 18.0325 0.597023 +4040 4 40.0442 9.94417 29.7674 -4.45736 4.50836 13.2228 +4041 6 33.5752 11.9033 22.735 -22.7947 23.9621 15.9921 +4042 4 33.2963 12.1808 21.8555 7.18969 -8.33444 -8.87292 +4043 4 33.0376 12.5465 23.2695 22.9257 -24.0379 -3.52442 +4044 6 29.0301 38.739 2.44557 13.7604 -11.9544 -20.6568 +4045 4 29.2066 39.6607 2.23242 1.09325 2.62923 1.14408 +4046 4 28.4566 38.7797 3.20164 -8.68487 1.4276 10.4377 +4047 6 51.2789 6.14828 28.303 0.614736 -0.570337 1.8431 +4048 4 51.6973 5.27456 28.1665 -1.53436 11.093 -0.261734 +4049 4 51.6265 6.73477 27.6091 2.17001 -12.1019 4.10374 +4050 6 34.1129 16.6124 14.0322 -32.0491 -20.8609 -4.49638 +4051 4 33.8537 17.5241 13.9801 -4.99199 17.3104 -1.82528 +4052 4 35.0495 16.5739 14.0336 36.3732 5.94549 -0.19423 +4053 6 34.4398 40.0505 7.51971 -1.5967 1.86622 -34.5907 +4054 4 34.4907 40.736 6.82898 6.47702 11.7366 29.0204 +4055 4 34.1466 39.3906 6.89306 -3.09667 -23.6565 15.965 +4056 6 42.5416 22.9885 4.36731 16.709 1.02816 -9.65968 +4057 4 42.6773 23.0677 3.40021 -12.3994 2.37358 9.8727 +4058 4 41.6332 23.2481 4.59133 5.34809 1.54884 -5.45539 +4059 6 1.43335 11.7249 10.5915 17.9648 34.7983 -1.93775 +4060 4 2.18855 11.6351 9.93392 -25.2532 9.63542 18.7746 +4061 4 1.3761 12.7012 10.8984 13.7257 -41.7135 -20.7702 +4062 6 10.0197 17.1509 40.4023 -3.34945 -21.541 12.0793 +4063 4 9.07741 16.8499 40.449 26.596 5.40866 2.75879 +4064 4 10.6028 16.482 40.874 -24.6204 18.7768 -14.392 +4065 6 26.3793 1.16939 23.7984 9.5834 26.112 -20.0106 +4066 4 26.3482 1.63114 22.915 -1.08564 -15.7005 23.7132 +4067 4 26.8817 1.81632 24.3342 -3.35925 -10.5223 -0.68284 +4068 6 4.47487 16.2271 39.0058 33.4959 -10.553 -10.6989 +4069 4 4.63618 15.8937 38.0801 -2.33968 7.70086 24.4633 +4070 4 5.35244 16.1813 39.5129 -32.5033 1.65679 -19.7071 +4071 6 24.3835 39.8482 14.0852 2.84697 7.18038 -0.286146 +4072 4 24.1877 40.6985 13.6429 5.77715 -11.144 2.19115 +4073 4 25.1234 39.4426 13.6288 0.754333 1.29636 -3.16103 +4074 6 19.9701 19.0136 10.1131 -5.22385 -12.8057 23.8822 +4075 4 19.1001 19.3633 10.3498 -0.643873 5.13605 -7.14836 +4076 4 20.1315 18.3631 10.8504 3.64009 16.176 -24.2707 +4077 6 45.2329 15.0638 25.3099 -19.5547 20.2245 12.2671 +4078 4 44.4482 15.622 25.4263 4.62838 7.04728 2.57625 +4079 4 44.8851 14.3824 24.752 0.155489 -22.5403 -14.0061 +4080 6 47.6439 32.9533 29.9771 4.38746 -1.69347 6.40492 +4081 4 47.8622 32.5347 30.8309 -5.05982 6.77924 -7.14273 +4082 4 46.6855 33.0215 29.8843 -3.06966 -4.44082 4.14054 +4083 6 9.30872 14.1631 35.6268 19.7088 14.7601 29.7215 +4084 4 10.221 13.8687 35.4779 -5.99131 -8.3331 -9.89462 +4085 4 9.36538 14.5282 36.5395 -10.4264 -5.45721 -18.9107 +4086 6 0.534978 28.7509 32.1461 -15.0727 14.1973 -4.1115 +4087 4 0.468283 29.1163 31.2513 -2.72678 6.96628 5.64212 +4088 4 0.834469 27.866 31.9601 7.81775 -11.1437 7.49829 +4089 6 26.1375 14.1816 40.8286 20.1166 -40.7048 30.4826 +4090 4 26.3241 13.5573 41.5993 3.0023 20.8863 -27.3959 +4091 4 25.2151 14.3343 40.9319 -22.5068 13.4131 -3.44564 +4092 6 38.0468 1.72227 37.358 -19.6589 11.4537 -4.22791 +4093 4 38.2764 1.77906 36.4154 -1.14244 -2.14966 7.97792 +4094 4 37.182 2.20858 37.4052 20.9639 -13.8426 2.93072 +4095 6 43.3928 21.0193 0.385094 -33.4221 -4.11839 13.5226 +4096 4 43.2305 21.8771 0.864972 20.5484 -13.2955 -16.2126 +4097 4 44.243 20.9573 41.8451 7.78799 18.4844 3.58779 +4098 6 29.7343 12.3918 17.0888 -10.4088 14.6249 -44.7733 +4099 4 30.3573 13.1084 17.3121 -1.69191 -12.5137 15.8564 +4100 4 29.5365 11.7717 17.7855 9.28071 1.18848 24.195 +4101 6 21.0845 11.002 35.643 19.2467 11.9534 29.728 +4102 4 20.8387 11.9292 35.5336 -5.23529 -0.657509 -1.91086 +4103 4 20.6782 10.509 34.9529 -15.7216 -13.7754 -25.5995 +4104 6 24.3584 22.1274 17.054 -19.116 4.6391 -13.6617 +4105 4 24.8062 22.8618 16.6504 0.246813 15.5697 -7.02352 +4106 4 25.0581 21.6899 17.4914 19.3443 -19.237 19.9016 +4107 6 44.2632 9.62803 6.15095 12.4515 -7.11379 4.41615 +4108 4 44.6939 9.46248 5.31272 4.1824 -3.3463 -6.13814 +4109 4 43.3875 9.94101 5.94426 -13.441 6.05535 2.74078 +4110 6 40.7983 2.89203 6.29118 6.30341 -5.06299 2.94692 +4111 4 40.283 3.08384 7.0886 -2.93464 8.08246 -11.2803 +4112 4 40.6425 3.53992 5.58152 -5.48248 3.30556 7.46891 +4113 6 23.4927 29.787 25.2074 -17.9847 -14.6764 23.1638 +4114 4 22.9663 29.9524 24.4255 0.505661 2.84572 -7.25135 +4115 4 24.3189 30.243 25.1366 19.4862 15.0746 -12.06 +4116 6 45.2253 20.6067 7.48804 -4.5495 -5.9569 -0.737791 +4117 4 44.4771 20.6075 6.85512 7.98227 -4.73543 5.3389 +4118 4 45.4897 19.6858 7.65762 -3.7219 7.49041 -4.48952 +4119 6 44.1869 26.5802 16.6604 -2.53584 -23.4697 22.3036 +4120 4 44.4278 26.4187 15.7655 11.491 9.41288 -34.0672 +4121 4 43.9629 25.6676 16.9 -3.51956 3.82806 13.7521 +4122 6 23.5847 27.0608 18.0875 4.92857 -1.63386 -8.1099 +4123 4 23.1417 26.2886 17.6568 -1.85204 16.5134 12.3838 +4124 4 22.9956 27.5067 18.7318 1.2523 -15.787 -12.8337 +4125 6 45.1423 16.1006 8.91925 -12.5826 4.07054 -12.5551 +4126 4 44.1756 16.0018 8.7625 13.8686 2.25455 7.61002 +4127 4 45.2849 15.9649 9.86163 -1.87368 -3.25302 7.37304 +4128 6 39.0195 15.168 5.20911 22.9796 -5.95468 -13.3261 +4129 4 39.8169 15.5451 4.76197 -16.8333 -0.501818 4.44847 +4130 4 38.2997 15.7872 5.12886 -6.79784 14.0419 -3.1922 +4131 6 40.4728 4.77172 20.098 -25.5728 -7.96759 5.38455 +4132 4 41.2852 4.73631 19.62 25.1414 0.345713 -9.53623 +4133 4 40.6586 5.20983 20.9254 2.90807 4.2574 9.49937 +4134 6 35.8334 28.4358 39.8978 -29.6544 -30.7382 0.627816 +4135 4 35.064 27.7738 39.8775 30.8234 30.4338 1.60118 +4136 4 36.4992 28.0138 39.3349 2.0747 -0.608826 -0.916217 +4137 6 26.5626 3.56604 2.67563 -12.8067 -1.70274 -2.52813 +4138 4 26.0244 3.493 1.8476 6.72613 8.7381 24.6483 +4139 4 26.0719 4.09981 3.36162 5.66066 -13.1585 -23.5937 +4140 6 2.95645 21.6514 17.6824 -3.82104 6.40043 0.291571 +4141 4 2.91294 22.1823 18.4797 -6.37673 0.600795 10.7096 +4142 4 3.68258 22.033 17.1814 1.62588 2.51689 -6.09233 +4143 6 12.886 25.0591 25.9256 19.9254 19.7817 -8.37483 +4144 4 13.3104 25.904 25.618 -13.2675 -16.998 3.60223 +4145 4 12.0452 24.9678 25.4656 -4.65807 1.85418 -5.64346 +4146 6 41.5793 20.6554 14.1751 9.92193 3.46069 0.25892 +4147 4 42.3122 20.2044 13.7523 0.767115 -12.7084 -7.64783 +4148 4 41.9959 21.4893 14.4245 -8.84771 2.34114 1.73285 +4149 6 1.24495 39.6039 11.5378 16.0363 -42.6363 3.17437 +4150 4 1.64626 38.7705 11.134 -18.3255 36.4754 4.46196 +4151 4 1.41802 39.4632 12.4909 -5.9615 12.3362 -8.98123 +4152 6 16.0218 39.0109 34.0619 -0.331369 12.6721 -5.4452 +4153 4 15.5475 38.1996 33.7806 5.75571 19.7523 -4.5346 +4154 4 15.9899 39.7855 33.4251 -7.29137 -28.599 9.21448 +4155 6 20.567 7.02475 25.5588 2.3848 7.82756 -0.6535 +4156 4 20.909 7.86076 25.1782 -7.45606 -9.2474 3.61042 +4157 4 19.6275 6.99553 25.3185 5.42042 5.25175 -3.5088 +4158 6 45.1928 25.5902 39.1787 -21.925 2.17874 18.9559 +4159 4 45.8631 26.0435 38.6892 20.8233 13.1115 -15.3132 +4160 4 45.3324 24.6675 39.0115 4.42968 -17.7425 -2.36405 +4161 6 19.9342 40.1138 28.2835 12.5964 -14.0671 -7.25792 +4162 4 19.0067 40.1593 28.0096 1.46425 5.68018 7.52545 +4163 4 20.128 40.8224 28.917 -7.48392 0.334406 -3.99949 +4164 6 26.4878 14.2069 27.3684 6.98603 -7.23951 -28.1548 +4165 4 25.5412 14.1932 27.2537 -20.7302 0.754551 -2.34698 +4166 4 26.606 14.4537 28.2745 0.836708 4.29804 26.5652 +4167 6 51.3489 25.9487 3.45136 10.7849 20.7191 -13.686 +4168 4 51.0453 25.2386 4.01334 -1.8549 -15.8565 1.21982 +4169 4 51.853 25.5737 2.69356 -6.32678 0.0553236 13.0587 +4170 6 20.1633 26.1247 2.67289 8.83438 -16.1267 5.68002 +4171 4 20.5345 25.2411 2.88723 -1.43181 13.9101 -1.64203 +4172 4 19.9438 26.1088 1.72974 -0.778515 0.427063 3.21599 +4173 6 3.13549 11.9681 27.2232 16.3616 22.3682 9.86323 +4174 4 2.68005 12.663 26.7181 4.92926 -3.58697 -0.471129 +4175 4 3.70389 12.4466 27.8862 -15.0224 -10.9098 -14.9284 +4176 6 30.1793 26.3687 4.00051 28.7119 -30.2966 58.1206 +4177 4 30.7801 25.8341 3.46925 -1.584 2.83444 -17.1702 +4178 4 29.6371 26.9341 3.51662 -25.563 30.6813 -37.7958 +4179 6 19.3205 20.6733 30.5441 -31.721 -6.25106 8.6959 +4180 4 19.1895 21.5008 31.0287 11.509 1.10551 -1.6952 +4181 4 20.2026 20.5869 30.2 22.6938 9.52703 -0.947482 +4182 6 13.5381 36.2475 0.344803 0.685356 24.2985 -17.2657 +4183 4 13.9232 37.1122 0.0997808 14.0363 -10.2996 17.9143 +4184 4 12.867 36.2368 41.5779 -17.3214 -19.7281 -1.62589 +4185 6 13.6931 21.7661 35.9637 -11.3229 -11.9655 -19.5688 +4186 4 13.4645 21.416 35.0694 1.68887 6.71419 14.5774 +4187 4 14.5559 22.1488 35.8465 12.3178 6.48213 0.887249 +4188 6 39.4176 1.76287 25.342 34.0854 -16.9064 9.57103 +4189 4 40.0026 2.33061 25.8435 -14.6367 28.4588 7.32056 +4190 4 40.0689 1.04185 25.2643 -19.5027 -7.65211 -10.5764 +4191 6 18.2964 6.13492 35.8264 -1.82227 -5.92686 -23.3299 +4192 4 18.1639 5.26767 36.254 2.04199 12.8657 6.45456 +4193 4 18.4232 6.85005 36.4651 0.375802 -9.94466 7.47089 +4194 6 2.53148 24.639 10.0969 -49.4669 34.6161 -0.50772 +4195 4 3.3243 24.1433 10.0889 43.7683 -7.59463 9.24933 +4196 4 2.65209 25.5465 10.4987 14.0059 -27.2835 -7.72375 +4197 6 35.8204 9.94567 1.34298 17.6587 14.9905 11.506 +4198 4 36.311 10.4135 0.64327 -4.10869 -3.12473 7.53129 +4199 4 36.1923 10.315 2.19711 -13.0886 -16.0695 -26.9686 +4200 6 29.0171 17.933 41.5847 -7.4648 10.4738 41.1296 +4201 4 28.4325 17.2741 41.1888 4.90819 -0.226834 -17.309 +4202 4 29.634 18.3354 40.9804 6.59061 1.40283 -25.0927 +4203 6 46.0097 27.0807 25.8707 -17.7195 2.90801 -6.40423 +4204 4 46.7639 26.9189 26.4445 5.86789 -6.79057 7.62258 +4205 4 45.3727 26.3443 25.9794 8.73043 2.74283 1.98831 +4206 6 28.1087 10.6569 35.9055 -15.3417 -26.5964 -30.9314 +4207 4 27.3182 11.0018 35.4375 11.5227 2.30745 10.116 +4208 4 28.4572 11.2922 36.5111 4.26863 23.9808 15.1461 +4209 6 25.95 20.1976 24.7821 3.31321 9.63686 -4.79579 +4210 4 26.7637 20.7132 24.6155 -9.40037 -7.04512 10.7501 +4211 4 25.7749 20.1865 25.7378 6.19451 4.49283 1.81458 +4212 6 32.2481 30.2487 10.2005 -0.567171 -33.888 25.4585 +4213 4 32.5217 30.8918 9.54162 14.407 -2.03846 -6.18424 +4214 4 32.9483 29.5597 10.4163 -8.30199 27.6945 -16.8968 +4215 6 5.04696 34.3919 23.8165 18.9071 9.10073 -2.65681 +4216 4 5.8517 34.9395 23.7378 -5.43375 -12.4066 7.00495 +4217 4 4.47737 34.8578 23.2154 -15.6684 -1.23826 -5.97721 +4218 6 29.6446 34.9396 23.1073 8.37026 13.2143 1.46186 +4219 4 30.146 35.227 23.8877 -4.79805 -2.96005 -2.8646 +4220 4 29.6355 33.9874 23.1398 -0.169507 -13.2925 4.62646 +4221 6 52.2021 25.2197 36.2484 0.203165 -13.9358 18.8619 +4222 4 51.9199 25.3821 37.1814 5.20177 -0.668093 -22.6011 +4223 4 52.2823 24.2449 36.2046 0.468647 8.20491 -0.432122 +4224 6 6.9564 41.2598 14.9786 17.963 -12.3423 -19.5336 +4225 4 7.05881 41.0384 15.8913 -5.14113 -1.34859 16.0369 +4226 4 7.66895 40.7276 14.5577 -14.5347 12.9973 2.09466 +4227 6 27.6566 39.1405 4.67566 -15.1179 -12.1251 22.0677 +4228 4 26.8424 38.6352 4.89635 10.0979 9.09612 -9.05456 +4229 4 28.2356 39.0161 5.44259 -0.0995191 -2.46215 -4.35417 +4230 6 44.4488 15.8848 30.3925 -17.4686 4.63448 -32.2897 +4231 4 43.6243 16.41 30.3099 13.0937 -10.0294 9.08699 +4232 4 44.649 15.6212 29.457 1.77951 4.94888 23.2191 +4233 6 27.3024 38.1054 13.0907 0.224949 -17.5042 -4.12929 +4234 4 27.6483 37.328 12.5833 -5.61487 10.2238 13.6353 +4235 4 27.1416 37.8221 14.0243 3.20236 0.189733 -16.1751 +4236 6 26.6663 32.9851 36.8362 -23.8807 -10.2072 10.655 +4237 4 27.4028 33.4987 36.5569 24.2269 11.6336 -10.1628 +4238 4 26.2735 33.5165 37.5295 -1.35435 2.25064 8.62378 +4239 6 26.3226 28.1988 31.7158 32.4613 11.5871 5.04411 +4240 4 26.7492 28.3346 30.8217 -6.54697 -0.873531 32.5908 +4241 4 26.9302 28.5068 32.4691 -17.7353 -8.90623 -33.5497 +4242 6 49.2114 35.7792 23.3295 1.46842 19.8344 9.76806 +4243 4 49.8184 36.2235 23.9243 -3.28067 3.63886 4.6357 +4244 4 49.746 35.0988 22.9506 10.5329 -22.9043 -16.5919 +4245 6 44.2369 15.3613 33.5367 -0.695853 -9.37614 14.4104 +4246 4 44.9539 15.1613 32.9326 3.59625 1.2978 -8.28609 +4247 4 43.6189 15.9562 33.0977 0.720121 5.36694 -8.04858 +4248 6 16.6517 35.2697 14.032 -14.9609 -5.91625 -15.8105 +4249 4 16.8478 36.086 14.4923 5.97715 10.4369 8.21626 +4250 4 15.7311 35.3947 13.7134 15.021 -1.16653 5.16189 +4251 6 45.2991 21.4701 12.0564 -47.5016 11.1637 19.3857 +4252 4 45.9844 21.105 11.5386 20.9258 -26.0087 -22.2564 +4253 4 44.5936 20.7913 12.2178 25.8967 12.3347 -6.55717 +4254 6 51.6438 5.33792 20.1099 7.42219 12.4384 36.9688 +4255 4 51.7517 5.79258 20.9932 -2.42789 -17.2577 -23.3969 +4256 4 50.9203 5.81642 19.7 -6.55397 4.36408 -6.3714 +4257 6 22.6153 27.305 0.955308 -12.5158 1.22245 6.52354 +4258 4 21.8819 27.8542 1.31405 9.62632 -7.19502 -8.89748 +4259 4 23.0385 27.8458 0.276527 0.370713 4.24399 -0.0338259 +4260 6 46.8868 12.1467 22.3289 10.3551 9.03073 -1.70047 +4261 4 46.473 12.5446 21.5671 -2.12653 7.07083 -14.4911 +4262 4 46.1639 11.6922 22.7348 -15.0603 -15.1984 17.3736 +4263 6 33.7555 5.60359 25.2366 8.41588 -11.9289 0.48427 +4264 4 34.4013 5.10188 24.7086 -2.4022 4.68399 3.96997 +4265 4 33.0757 5.86414 24.6127 -5.93503 4.46215 -0.558809 +4266 6 44.2476 18.1243 27.2334 30.0322 17.9475 -5.65933 +4267 4 44.0927 18.7931 26.5253 0.465456 -9.97561 17.2792 +4268 4 45.207 18.2464 27.4768 -29.0014 -6.50023 -5.41996 +4269 6 5.27814 37.006 29.0846 -42.995 37.8911 -11.235 +4270 4 4.83357 37.8684 28.7516 22.264 -36.721 16.075 +4271 4 6.19253 37.2033 29.2507 20.6764 5.54169 3.86921 +4272 6 20.033 5.01392 38.9409 6.34377 -32.2179 -4.45843 +4273 4 19.8009 5.56625 39.6765 -4.47316 13.7366 14.9565 +4274 4 20.2948 4.14306 39.3359 -6.8578 18.535 -7.22498 +4275 6 17.9112 2.77214 33.8677 -16.6976 6.01838 23.4157 +4276 4 18.6113 3.34266 33.5322 6.18073 5.31505 -2.96417 +4277 4 17.3526 3.28629 34.5246 17.6921 -17.568 -20.3177 +4278 6 5.56788 23.3774 22.3326 -7.55986 13.5725 18.1102 +4279 4 6.25354 23.3408 21.6412 1.32241 8.57002 8.68476 +4280 4 5.72116 24.1623 22.9232 3.31135 -14.4794 -19.5174 +4281 6 12.7438 28.0244 40.0809 14.6998 26.4392 -25.8726 +4282 4 12.8099 29.0023 40.1455 -0.120572 -14.3051 2.54846 +4283 4 13.1526 27.8611 39.1965 -9.74214 -4.86635 20.6942 +4284 6 50.5283 38.8014 28.4207 -10.7676 14.1923 -1.71082 +4285 4 51.0354 39.5212 28.0559 20.7423 0.788408 -10.014 +4286 4 49.7626 39.3052 28.7255 -7.2831 -13.6434 5.52883 +4287 6 33.5501 8.21498 17.8605 -32.9279 -35.4008 39.405 +4288 4 33.9027 8.87262 17.3189 24.9798 40.0041 -36.6225 +4289 4 33.9074 7.37462 17.5752 8.43731 -7.27798 -4.46199 +4290 6 34.6457 34.7004 17.7764 -12.4293 -15.9601 -10.9704 +4291 4 35.1223 35.3606 18.2944 6.48769 -0.751965 0.253856 +4292 4 35.2388 33.9528 17.5616 -1.14344 9.31979 5.2604 +4293 6 40.7233 5.29016 23.4005 8.26322 -6.33781 10.3585 +4294 4 41.4774 4.87923 23.8731 -9.49225 7.91527 -13.3731 +4295 4 40.0307 4.6112 23.3711 2.34129 5.18948 -0.0201455 +4296 6 16.9127 27.7621 14.4682 52.6044 -4.68653 -2.89351 +4297 4 16.0711 28.1345 14.4444 -59.8378 16.6137 -1.60006 +4298 4 17.4608 28.5627 14.561 1.7801 -9.46587 0.070581 +4299 6 29.0363 14.6633 5.00698 9.76413 -9.29226 13.7719 +4300 4 29.5096 13.8001 4.93115 -9.10936 16.1071 1.03458 +4301 4 28.802 14.7746 5.95339 2.50956 -1.40994 -14.9204 +4302 6 36.8445 17.7203 5.07362 13.6951 -24.032 -28.6565 +4303 4 36.3003 18.4061 5.45056 -9.17068 14.5835 0.43155 +4304 4 36.9783 17.8862 4.10178 -4.81067 2.65881 25.6667 +4305 6 27.7152 25.5071 34.8558 20.6182 -10.3116 10.9196 +4306 4 28.4128 25.1948 35.4689 -8.51497 -1.72528 -14.7569 +4307 4 27.3626 26.2325 35.3632 -10.8781 12.0961 2.58089 +4308 6 24.7577 17.2803 18.064 -3.70908 -2.75228 5.17573 +4309 4 25.2464 17.9619 18.5343 4.21458 5.85634 1.04617 +4310 4 24.0216 17.073 18.6635 3.98676 -0.349172 -5.54229 +4311 6 30.1887 1.57939 5.82314 -15.3902 21.7461 -57.8894 +4312 4 29.5204 1.81013 6.46928 0.301846 -2.58557 7.21893 +4313 4 29.8355 2.03332 4.95505 20.4457 -28.7719 49.9963 +4314 6 37.4518 25.9014 8.44867 -40.4019 -33.5071 29.4213 +4315 4 38.3881 25.8301 8.67833 5.27698 -2.9507 2.74989 +4316 4 36.9261 25.2192 9.0364 31.48 35.4073 -33.2345 +4317 6 24.7717 7.01585 2.25321 22.1725 6.13312 -2.42992 +4318 4 25.3573 6.36243 2.67285 -8.4103 6.94319 2.38151 +4319 4 23.8861 6.6751 2.35128 -10.8992 -4.25211 1.65182 +4320 6 25.7992 38.8457 10.7505 7.22571 37.8744 -16.0906 +4321 4 26.2906 38.615 11.5103 14.31 -23.6918 34.358 +4322 4 26.1189 39.766 10.6411 -14.7913 -5.88601 -10.6141 +4323 6 0.557249 13.5851 28.1314 4.10373 25.7622 10.4527 +4324 4 0.335523 12.7734 27.7191 -4.86664 -22.4284 -15.6315 +4325 4 0.332586 13.4422 29.0593 -0.0574933 0.663208 0.855409 +4326 6 20.4027 17.1068 12.0342 -11.148 -26.8285 -23.5414 +4327 4 20.2541 17.2545 12.9674 -4.18463 -1.09026 14.619 +4328 4 19.9228 16.2663 11.7843 12.058 20.2306 8.20324 +4329 6 30.9875 7.38585 16.6706 43.1327 18.1844 -1.13431 +4330 4 31.2844 7.10043 15.7746 -9.95685 2.73348 15.1831 +4331 4 31.8198 7.8213 17.056 -34.7561 -19.1709 -8.28734 +4332 6 10.1956 5.78615 12.1691 19.1166 9.414 40.461 +4333 4 10.1305 6.30649 11.4071 -1.6074 30.0602 -42.5686 +4334 4 9.61456 5.08708 11.9844 -30.6818 -38.1141 -6.43609 +4335 6 18.4382 31.3444 24.1606 1.21336 -6.12525 2.83497 +4336 4 18.3965 30.3858 24.3134 -0.788465 1.61506 0.642095 +4337 4 18.2608 31.7571 25.0112 -0.825834 1.26386 0.0223154 +4338 6 27.8905 29.2615 29.2809 39.8074 15.5588 -29.008 +4339 4 28.4007 29.5348 28.4528 -32.3375 -5.53357 22.8869 +4340 4 28.6323 28.9656 29.8273 -8.8667 -4.73078 13.1255 +4341 6 38.3648 15.4483 29.7818 29.0993 -31.9427 29.9284 +4342 4 38.2401 14.49 30.0972 1.05022 38.774 -16.5136 +4343 4 39.2299 15.7257 30.2111 -34.0699 1.82394 -15.2271 +4344 6 21.7074 34.7851 5.58078 8.19375 -39.9271 5.99876 +4345 4 21.4944 33.8203 5.80476 0.548141 38.153 -5.97617 +4346 4 20.9458 35.3238 5.82701 -5.25279 -7.50871 2.73382 +4347 6 18.2117 16.8293 1.01571 -12.7233 9.06437 9.63769 +4348 4 17.5846 17.1799 0.363518 5.67247 -6.87112 -0.25098 +4349 4 17.8106 17.1001 1.86952 7.78128 -5.5379 -6.7416 +4350 6 43.5131 18.5098 39.3469 22.8992 -24.809 -24.744 +4351 4 42.9473 19.1501 39.756 -14.025 22.4758 -1.21679 +4352 4 43.733 18.7829 38.41 -14.2449 3.90475 27.8798 +4353 6 17.7973 10.0724 35.5497 11.3899 1.25644 -17.5776 +4354 4 17.9076 9.35875 36.1674 -1.9111 -9.85084 12.7139 +4355 4 18.4727 9.8826 34.8661 -11.1758 5.45367 7.50841 +4356 6 36.5836 30.5676 29.0795 -26.735 36.4018 -15.4516 +4357 4 36.5101 31.4618 28.6208 1.83791 -30.0083 14.6126 +4358 4 37.4767 30.2665 28.9506 20.8385 -5.81304 -4.31186 +4359 6 38.5024 35.9654 10.4302 15.5283 7.61871 55.4477 +4360 4 38.713 36.6589 11.1463 -7.3207 -22.805 -33.4203 +4361 4 38.3781 35.1576 10.9824 1.19538 10.4075 -12.7486 +4362 6 43.3976 18.7941 34.3717 -4.38817 -12.2014 30.3889 +4363 4 43.0627 18.1963 33.6763 0.988603 1.53223 14.3474 +4364 4 43.2603 18.4022 35.293 0.0857578 9.32555 -37.8245 +4365 6 11.0576 40.22 6.11206 -6.0837 -9.04747 -4.15047 +4366 4 11.6426 40.8981 6.46389 1.08734 7.77423 2.35531 +4367 4 10.1474 40.5638 6.06331 9.30243 4.06404 0.87098 +4368 6 48.3282 13.7431 24.4718 -8.87905 25.3224 16.0087 +4369 4 47.8536 13.4091 23.7195 -8.5266 -8.47545 -16.9724 +4370 4 47.8942 14.6072 24.6749 14.3726 -19.4181 -2.72093 +4371 6 1.47819 25.7805 23.7819 -0.0731812 -13.4431 -3.72387 +4372 4 0.822875 26.4404 23.4927 11.4147 5.84295 7.97453 +4373 4 2.19403 26.202 24.2849 -5.19934 9.21725 -1.17005 +4374 6 20.5754 0.0393205 21.1081 25.6075 5.05031 -17.3956 +4375 4 19.8484 0.361847 21.622 -17.4675 -5.38456 12.9096 +4376 4 20.5586 40.9849 21.0455 -11.1839 1.66381 7.6849 +4377 6 37.6642 12.8991 30.7037 -9.9457 -20.8438 -29.8221 +4378 4 37.1371 12.462 29.9889 18.2914 6.1257 8.16018 +4379 4 36.9745 13.1334 31.2979 -14.5618 11.4049 21.409 +4380 6 49.47 17.3794 9.25364 5.30826 8.19981 -9.14457 +4381 4 48.5231 17.6061 9.31556 15.6584 -1.48937 -5.70503 +4382 4 49.8852 17.9254 8.53549 -14.9109 -12.0851 17.4703 +4383 6 34.3662 5.35535 17.144 13.1974 2.57034 -29.0571 +4384 4 34.5198 5.2998 16.166 0.54303 4.43319 20.4174 +4385 4 33.4623 5.07036 17.243 -16.3394 -6.24992 8.38082 +4386 6 14.7833 27.6665 0.0728061 -6.74966 -7.64198 -7.69033 +4387 4 13.9925 27.8402 41.4242 12.1928 3.48747 9.75107 +4388 4 15.1668 28.5017 0.401621 -7.96817 -0.0208253 -5.02821 +4389 6 48.8656 15.5206 20.7458 -9.86138 0.136748 20.6241 +4390 4 49.0651 16.3952 20.4263 0.209458 6.72405 -7.85333 +4391 4 49.1204 14.8922 20.0789 6.79298 -9.16117 -16.8166 +4392 6 23.807 40.3882 20.3905 -3.398 23.5063 24.1729 +4393 4 23.5208 41.0259 21.1064 9.42377 -19.8715 -22.5683 +4394 4 24.7282 40.1652 20.6096 -6.91059 4.34471 -3.10789 +4395 6 35.1847 31.5046 13.7021 -31.0181 23.9456 -35.1619 +4396 4 34.2309 31.3725 13.4471 24.927 2.88592 7.27171 +4397 4 35.3946 30.8036 14.2945 4.95161 -20.634 19.3451 +4398 6 10.9658 9.01332 39.5058 -15.2714 21.9147 -18.395 +4399 4 10.5965 9.92979 39.4 9.97221 -25.6919 2.69722 +4400 4 11.1763 8.90125 40.4322 -2.36933 4.41176 3.08643 +4401 6 53.2091 4.88966 16.6226 -14.1926 -12.3632 -40.3028 +4402 4 53.7513 5.3458 17.242 7.58091 5.46958 35.753 +4403 4 52.4727 4.38631 17.0042 6.19997 4.37068 9.30068 +4404 6 7.84194 33.803 26.1542 28.433 15.6582 -32.2535 +4405 4 7.6241 34.0763 27.0539 6.31302 8.01731 -0.629847 +4406 4 8.43319 34.4994 25.6777 -29.4311 -29.3345 32.8186 +4407 6 31.3263 27.9445 6.27534 4.23256 -31.0286 -11.1959 +4408 4 31.9071 27.4889 6.92578 -8.71467 11.4818 -6.48617 +4409 4 31.157 27.2952 5.54778 3.06851 13.2477 11.4148 +4410 6 31.3665 2.16522 41.0549 8.67281 8.84877 18.675 +4411 4 31.764 2.22522 0.0553479 -13.0589 -8.62932 -24.7178 +4412 4 31.1679 1.24258 40.8683 -0.324156 -6.15668 4.61941 +4413 6 33.7659 4.25511 35.8987 -17.0312 -3.82062 1.06926 +4414 4 34.343 3.86214 36.5812 -9.75418 2.24627 -3.55813 +4415 4 32.8029 4.08293 36.1352 33.1171 1.27305 -1.46623 +4416 6 47.9658 16.0637 29.8469 2.67107 -7.93457 21.4822 +4417 4 48.7643 16.2814 30.3583 0.589987 0.219824 -12.8585 +4418 4 47.4335 15.6159 30.5321 -1.60863 4.8928 -15.0046 +4419 6 49.3312 10.0914 28.5924 -0.28152 -2.80953 -5.35856 +4420 4 48.5695 10.6519 28.8218 4.15282 -2.34898 -5.74021 +4421 4 49.4995 10.1231 27.6243 -2.44246 2.9592 14.5426 +4422 6 21.4058 27.7857 29.7524 8.26148 -8.5709 13.934 +4423 4 21.8935 27.2574 30.4222 -7.07544 0.199766 -18.4014 +4424 4 21.2999 28.6278 30.1835 -3.48366 18.9655 1.67033 +4425 6 11.6744 39.4982 25.8468 7.90293 7.18169 -2.58674 +4426 4 12.2285 38.7361 26.0681 1.40058 3.92388 1.36909 +4427 4 10.8023 39.1241 25.7384 -12.6269 0.672841 -0.990747 +4428 6 22.9696 39.3076 7.85132 -6.07512 -3.4122 -1.68244 +4429 4 22.2682 38.6524 7.98148 0.173976 5.86283 1.52023 +4430 4 22.7132 40.0561 8.41581 1.67877 -3.24138 -2.90234 +4431 6 42.551 35.9177 31.3369 11.821 -63.1978 11.5341 +4432 4 42.5803 35.466 30.4647 -4.4966 22.226 11.3725 +4433 4 42.4036 36.8376 31.2573 -6.84366 36.9754 -14.9488 +4434 6 33.6582 14.7374 3.97797 20.0935 -7.17859 -40.4554 +4435 4 32.8645 15.2412 4.10613 -20.5582 11.3796 6.05129 +4436 4 33.8494 14.8388 2.99484 -4.26498 -3.76663 30.6135 +4437 6 36.6985 8.59579 17.521 17.5186 -20.4505 -17.8166 +4438 4 37.2174 8.05238 16.87 -10.1577 15.2162 18.3492 +4439 4 36.2061 9.2161 16.9727 -6.85471 3.87096 1.58869 +4440 6 20.8134 32.4132 17.3224 -0.15138 -19.2041 8.32641 +4441 4 20.2101 33.0681 16.9297 -8.31182 -6.81981 10.9196 +4442 4 20.3788 31.7527 17.9441 5.10322 26.2393 -19.6477 +4443 6 20.7088 35.3183 14.0957 -11.7768 -25.3725 -13.8548 +4444 4 21.261 35.5893 13.3574 6.77827 9.37653 -4.07387 +4445 4 20.8679 35.9028 14.8214 6.04206 13.2639 9.85712 +4446 6 20.2377 2.51389 40.1721 -7.12285 -8.41588 24.6249 +4447 4 19.7963 2.31331 41.0421 14.3479 1.04867 -24.2175 +4448 4 20.7189 1.71371 39.9103 -4.456 1.41042 1.49289 +4449 6 15.0332 14.4679 0.20602 13.2809 -6.14192 -34.7112 +4450 4 15.5535 13.6508 41.8516 -13.9549 30.8146 5.37449 +4451 4 15.3124 15.2392 41.5458 -1.11857 -25.4589 11.3055 +4452 6 24.8198 37.3334 18.5262 -9.71694 12.1129 21.4379 +4453 4 24.5044 38.0178 17.9266 6.55828 0.975012 -4.85481 +4454 4 24.4839 37.6255 19.4009 7.37292 -12.3795 -13.3571 +4455 6 3.16023 27.7824 5.25746 -7.59771 -9.49442 8.09122 +4456 4 2.57386 27.9573 6.05068 26.7372 -11.3185 -11.6141 +4457 4 4.04718 27.3724 5.4685 -26.4098 5.90831 3.92345 +4458 6 37.1274 39.059 36.0582 -20.0626 39.3499 3.12364 +4459 4 37.4397 39.697 36.7497 0.155645 -22.9334 -11.3782 +4460 4 37.5741 38.2261 36.1006 18.9616 -13.4483 8.05827 +4461 6 41.3496 16.372 3.85306 -8.55617 -26.9153 -3.74777 +4462 4 41.2863 17.3336 3.84263 10.0449 1.9656 13.5452 +4463 4 42.0245 15.9886 4.46176 -7.16622 24.1057 -6.4954 +4464 6 15.5715 3.1806 35.3543 4.49903 -8.79025 -44.1337 +4465 4 15.0747 3.51322 34.5661 7.45265 -4.29831 20.3405 +4466 4 15.2394 3.62675 36.1076 -11.9729 17.6287 21.2524 +4467 6 33.1697 24.252 7.98021 17.4163 -35.2043 24.5175 +4468 4 33.373 24.4892 7.07941 -5.88693 14.0606 -13.9779 +4469 4 32.5854 24.8767 8.38373 -10.6809 23.5743 -3.02942 +4470 6 35.8792 29.7453 15.5891 -14.351 2.75051 -7.10357 +4471 4 36.7674 29.6271 15.8378 44.9858 5.9786 2.16229 +4472 4 35.4705 29.0828 16.1298 -19.5083 -3.35284 8.18061 +4473 6 17.5951 36.8258 41.8642 -13.8657 0.640745 -39.4401 +4474 4 18.0986 36.7885 0.752491 19.5286 0.61142 14.8967 +4475 4 18.204 36.9888 41.0995 -4.16013 -2.78766 23.3657 +4476 6 26.5622 4.14757 31.1303 -11.2209 -47.8968 -15.8259 +4477 4 27.2883 4.63526 31.456 28.856 27.2634 11.544 +4478 4 26.9475 3.23966 30.9928 -12.9924 23.1667 5.46977 +4479 6 31.9456 1.33308 34.4467 -12.9904 6.64728 -11.4505 +4480 4 32.8071 1.19449 34.8725 -11.0783 -3.65615 8.33208 +4481 4 31.1956 1.0725 35.0172 18.2758 0.413953 2.527 +4482 6 24.503 14.7492 2.38048 9.24208 -0.0712211 -0.802907 +4483 4 24.1928 14.0003 2.93847 14.4388 11.7071 -7.35684 +4484 4 25.4689 14.9243 2.53228 -19.8697 -9.93034 3.69906 +4485 6 25.7634 20.9148 27.525 0.946636 -0.977661 -1.30084 +4486 4 25.4997 20.5428 28.395 3.38508 9.32598 -11.7317 +4487 4 25.6529 21.8806 27.5755 0.284497 -3.23384 4.14496 +4488 6 18.1477 40.1511 30.6505 2.638 -12.7558 5.82509 +4489 4 18.5379 39.2542 30.773 0.361891 20.0487 -3.45439 +4490 4 18.8736 40.7943 30.5754 -0.793328 -5.73314 0.616918 +4491 6 46.8137 23.9108 24.5765 -6.45001 25.2139 -38.2053 +4492 4 46.156 24.4917 24.0674 25.2521 -23.4518 17.6745 +4493 4 47.3533 23.4819 23.8873 -7.92808 3.44465 4.72259 +4494 6 45.5993 22.6806 26.5072 -4.87261 3.12825 -8.14378 +4495 4 46.0946 22.9584 25.7273 -3.42504 -3.72677 5.16847 +4496 4 46.0209 23.1613 27.2227 -5.79148 -3.32105 5.25932 +4497 6 20.0977 4.47574 26.7104 -1.85738 36.2438 14.3308 +4498 4 20.3766 5.37803 26.4593 -10.8474 -9.08605 12.6513 +4499 4 20.6066 3.98633 26.1049 14.7704 -34.5311 -24.6657 +4500 6 35.268 26.6035 12.5547 25.3434 4.5593 25.1203 +4501 4 35.7054 25.7374 12.5354 -13.4481 2.49909 -6.64065 +4502 4 35.8431 27.0669 13.1929 -15.092 1.56141 -12.9558 +4503 6 3.25549 33.9664 12.2985 -21.2488 -6.99508 3.93395 +4504 4 2.30606 33.7392 12.3085 7.5225 -4.25393 -1.25154 +4505 4 3.25844 34.917 12.332 8.53638 16.5693 1.24934 +4506 6 36.6808 1.27299 25.5856 -28.051 -2.86161 17.5249 +4507 4 37.6164 1.46673 25.6835 8.21338 5.71919 3.59986 +4508 4 36.1703 1.6124 26.3685 15.6278 -2.9361 -18.4357 +4509 6 16.8737 4.664 24.0353 -31.9925 -2.01789 -27.2632 +4510 4 15.8786 4.73848 23.8401 40.5517 -2.65221 8.73903 +4511 4 17.2589 4.19458 23.2519 -3.48506 7.68373 17.7614 +4512 6 39.6701 15.0742 7.83356 -1.71206 -7.05123 2.14494 +4513 4 39.2725 14.2274 8.02711 2.44544 -9.24519 17.4119 +4514 4 39.3892 15.1326 6.9218 7.69265 14.011 -7.76766 +4515 6 9.96731 20.1909 2.92864 -13.1382 1.0323 -16.144 +4516 4 9.71565 20.5309 2.05786 3.65664 7.03968 6.64426 +4517 4 9.8995 19.2377 2.78093 4.24026 5.10291 12.3576 +4518 6 23.4077 4.6159 15.27 -3.48308 -16.1533 -1.5067 +4519 4 23.619 4.71624 14.3536 6.29203 -7.01184 -22.1313 +4520 4 23.1672 5.50294 15.4683 -4.33935 19.8524 20.6561 +4521 6 23.5267 41.6518 17.9122 -9.44104 0.807914 21.3506 +4522 4 23.7067 41.2659 18.7956 7.59245 -0.294373 -11.029 +4523 4 22.6339 0.0834245 18.0732 1.82991 3.48892 -13.1537 +4524 6 30.9316 4.82324 1.33107 45.9774 51.3713 7.99935 +4525 4 30.5768 4.02682 1.05687 -28.0042 -54.4029 -17.3695 +4526 4 31.8094 4.8761 0.879215 -15.6392 -0.833181 8.5221 +4527 6 29.2201 33.7587 18.5991 58.073 2.92721 -1.85527 +4528 4 30.1837 34.1183 18.6008 -42.2538 -17.2347 0.0641557 +4529 4 28.6837 34.5413 18.5643 -15.6262 17.5996 3.33909 +4530 6 23.1221 16.7099 3.68521 11.8431 -16.3115 0.0733348 +4531 4 23.6562 16.338 2.95547 -9.45134 2.67217 9.8165 +4532 4 23.048 17.6538 3.54099 -2.31098 6.59774 -1.54538 +4533 6 34.8961 26.7639 31.7325 -1.99602 4.46994 3.67284 +4534 4 35.0929 27.7139 31.562 -2.18198 -17.8875 -5.58085 +4535 4 35.0252 26.2302 30.9312 2.47742 18.1005 -1.54363 +4536 6 7.11189 40.7663 20.959 14.901 4.90705 15.7674 +4537 4 6.49418 40.4573 20.3006 -5.17655 -2.88906 -15.6427 +4538 4 7.9749 40.9101 20.5297 -6.61986 -3.78335 -7.15935 +4539 6 52.4451 9.69387 11.9379 -8.46192 -13.0679 -16.1645 +4540 4 52.1167 8.90553 11.4509 5.46474 18.3719 13.4625 +4541 4 53.1134 10.0871 11.3593 -6.16158 -0.354597 4.80602 +4542 6 12.0344 32.7576 27.7445 1.28323 7.36678 12.5499 +4543 4 11.2848 32.2741 27.3627 7.37999 2.33687 -5.47139 +4544 4 12.7987 32.654 27.1746 -1.40521 -5.62475 -4.84597 +4545 6 15.7821 18.5441 0.84801 8.76354 -4.35468 -11.8188 +4546 4 16.4439 18.9467 1.42581 -3.0166 1.81121 1.10538 +4547 4 14.9492 18.5892 1.29924 -12.8156 0.756803 9.02992 +4548 6 30.9925 13.9418 7.42386 -4.40747 -9.92517 -19.1249 +4549 4 31.0137 13.4754 6.53341 6.38174 17.9129 28.0089 +4550 4 31.6996 14.6103 7.52177 -5.32565 -11.3142 -7.68087 +4551 6 23.9405 39.5605 3.5435 10.8606 -6.43074 -8.73391 +4552 4 24.3095 38.7805 4.04208 -2.00396 18.4511 -18.0645 +4553 4 24.6123 39.8651 2.88148 -9.69774 -9.50421 15.8523 +4554 6 53.2462 13.9551 2.00337 -15.5118 -12.0942 -3.71099 +4555 4 54.104 14.269 2.28215 12.5804 5.35006 1.30654 +4556 4 53.0522 14.3304 1.13281 7.32968 -0.777694 2.32044 +4557 6 29.4483 26.4268 7.81741 -0.171572 11.4439 -18.4732 +4558 4 29.8672 26.7876 7.00927 -3.33338 -4.99995 18.6366 +4559 4 28.5088 26.3872 7.58736 -4.03891 -2.78124 5.15679 +4560 6 24.6251 23.6043 31.0935 -26.8137 17.7603 -44.4691 +4561 4 23.7139 23.2229 30.9355 29.773 11.0738 8.78977 +4562 4 24.7983 24.2076 30.2965 -2.98074 -30.8217 36.523 +4563 6 33.658 19.3188 40.511 -4.29932 4.0975 7.85681 +4564 4 33.8365 18.6271 41.1728 0.0947513 0.993086 -5.72158 +4565 4 34.3002 19.2334 39.7953 0.390848 -1.03282 -3.03706 +4566 6 0.558986 35.9852 14.2205 11.1667 11.0015 21.0521 +4567 4 1.21386 36.1432 14.9149 3.92292 -5.96876 -2.97707 +4568 4 0.043734 36.7876 14.3014 -15.3768 6.08493 -10.5247 +4569 6 7.05222 12.7587 15.7802 -26.1824 -15.4106 14.8382 +4570 4 6.35773 12.5373 16.4499 19.2033 7.53925 -13.5919 +4571 4 6.88557 12.0803 15.1093 4.12905 5.75416 0.888 +4572 6 7.8802 3.87979 22.4264 4.564 -30.6165 13.1651 +4573 4 7.61737 4.55637 21.8154 -5.12813 13.4305 -13.5146 +4574 4 7.59435 3.01808 22.0419 3.92228 16.9329 8.71162 +4575 6 50.747 32.0919 16.246 0.584829 29.9532 -6.88448 +4576 4 49.8575 31.8158 16.477 -3.66132 0.0213613 -0.234359 +4577 4 50.6533 33.048 15.9617 2.92819 -31.696 10.1835 +4578 6 15.3083 18.2099 30.0577 17.4273 -12.3999 25.5818 +4579 4 14.8795 18.523 29.2753 -13.2188 2.60124 -19.4058 +4580 4 14.9888 17.3027 30.2404 2.47215 8.3937 -6.40515 +4581 6 36.7253 25.4508 33.3862 -30.1432 30.6395 -17.6873 +4582 4 35.9871 25.9696 32.8546 42.334 -36.2451 27.5582 +4583 4 36.7428 24.5171 33.143 -7.68133 1.91065 -3.3758 +4584 6 16.5208 21.8449 20.262 -11.2097 8.64672 -3.63533 +4585 4 16.6085 20.9267 19.9682 1.68058 -0.497742 -2.90804 +4586 4 16.3112 22.3946 19.4823 4.36577 -8.59001 6.07269 +4587 6 44.2833 3.11948 30.0766 -7.99673 -6.73576 30.9987 +4588 4 44.2005 2.2232 29.7402 -0.794022 -7.70278 -4.62871 +4589 4 44.5183 3.67066 29.3503 7.77568 15.2131 -24.9404 +4590 6 51.0808 14.1269 27.7758 -27.047 -14.2895 -4.28411 +4591 4 51.175 15.071 27.7901 8.66575 19.7266 0.878182 +4592 4 50.1173 14.0309 27.5969 15.0189 -4.76366 3.10402 +4593 6 54.1497 15.8755 27.1203 10.9044 -5.07506 15.753 +4594 4 54.6247 15.0341 27.411 -19.35 18.5916 -21.6107 +4595 4 53.6213 15.8397 26.2863 11.6919 -13.2292 13.7718 +4596 6 26.7269 15.1716 34.5247 3.07047 6.28357 -2.56105 +4597 4 26.6547 16.15 34.5201 9.87746 -16.6036 -4.19036 +4598 4 27.4477 14.9176 33.917 -5.54963 13.4877 1.89491 +4599 6 34.6713 2.21044 27.481 35.3652 -9.42756 14.1603 +4600 4 34.3712 2.0217 28.3795 -9.10436 3.38048 -0.887416 +4601 4 33.9282 2.37922 26.9258 -24.4077 6.67858 -6.22498 +4602 6 36.3012 17.6491 40.388 5.86113 23.4658 6.44349 +4603 4 35.7206 17.1804 39.7974 -3.43874 -12.7236 -2.47465 +4604 4 36.6864 17.0408 41.0377 -6.22241 -0.114851 -7.42509 +4605 6 26.2819 0.194243 33.0916 -21.1162 -1.74839 5.89968 +4606 4 26.0541 0.792538 33.818 7.17118 8.51167 2.05738 +4607 4 25.4361 41.6393 33.0097 0.772233 -7.73624 -3.23605 +4608 6 5.19547 35.5715 31.6247 14.6733 -21.492 26.4929 +4609 4 6.10271 35.831 31.8735 -9.75028 2.17691 -1.53344 +4610 4 4.97694 36.0548 30.8519 -3.41417 18.4244 -29.6169 +4611 6 20.2195 22.0294 35.119 8.25657 -3.203 11.321 +4612 4 19.9286 21.1888 34.7559 -2.68712 -4.78598 1.15285 +4613 4 20.5567 21.7901 36.0152 -5.29706 4.10974 -20.8318 +4614 6 15.9087 36.5843 36.9399 0.69981 -30.9087 31.3945 +4615 4 16.5764 37.2836 37.0377 -3.33596 -3.14632 -1.27145 +4616 4 16.032 35.9777 37.754 -5.87689 21.7482 -34.0408 +4617 6 30.95 22.3912 3.57027 12.227 -51.3484 -20.5494 +4618 4 31.0645 22.6091 4.4902 1.82476 2.59415 19.1922 +4619 4 31.2691 21.4218 3.50648 -13.7255 40.3499 2.75328 +4620 6 47.0405 8.41049 14.2025 -7.26712 -13.7585 -23.7685 +4621 4 46.2225 8.31623 13.6472 18.9804 2.55096 13.7682 +4622 4 47.7321 7.85584 13.7597 -18.0416 11.4216 8.02226 +4623 6 34.1106 18.627 3.15563 -0.4946 23.1394 22.2065 +4624 4 34.672 18.2914 3.86301 0.996255 -3.71784 -4.49801 +4625 4 34.2399 18.1173 2.36738 0.542984 -13.2578 -17.3669 +4626 6 26.7976 25.3916 12.343 -23.6037 -44.5624 17.4882 +4627 4 27.2059 26.2338 12.4335 13.1462 29.8808 4.32264 +4628 4 26.6887 24.995 13.243 7.37483 11.5945 -21.6739 +4629 6 22.6215 25.7777 30.8835 17.9212 -8.3502 11.6983 +4630 4 23.3826 25.7056 31.4928 -6.70991 6.16838 -4.71983 +4631 4 22.2455 24.8881 30.8847 -4.10822 -0.13742 -3.2228 +4632 6 23.6315 9.78689 35.7599 5.48292 -2.30097 -0.625566 +4633 4 22.8113 10.2893 35.7248 -4.77612 1.7474 -0.383276 +4634 4 23.3643 8.87406 35.5171 2.31753 16.9109 3.97959 +4635 6 10.4044 36.7742 9.63922 -25.0741 -4.1625 3.51028 +4636 4 9.48479 36.4361 9.55892 17.1497 7.1291 1.06445 +4637 4 10.7029 36.9295 8.73946 3.49181 4.27039 -8.54773 +4638 6 4.00239 32.4234 25.8687 17.3833 10.7639 11.9139 +4639 4 4.35688 32.9952 25.1699 -1.7627 -0.965582 -1.95819 +4640 4 3.3252 31.8731 25.4905 -12.2764 -14.2405 -10.2138 +4641 6 29.0717 26.0252 18.6551 27.2015 -27.7815 2.54409 +4642 4 28.1485 25.9947 18.9226 -9.28828 -8.18845 2.68073 +4643 4 29.5616 25.1801 18.9271 -24.0321 31.3207 -7.4501 +4644 6 15.3034 1.33037 27.9713 -8.15532 13.2931 -1.88459 +4645 4 14.9824 0.900448 27.1643 -4.10476 8.37726 9.18093 +4646 4 14.8435 2.19317 28.1161 8.64797 -17.4448 -9.70896 +4647 6 48.6122 2.88813 22.9601 -14.0575 20.6462 10.9468 +4648 4 48.3097 2.01316 22.7294 4.97712 -8.72373 -1.92059 +4649 4 49.4728 3.0448 22.5739 5.56154 -9.57595 -10.4155 +4650 6 53.0134 0.348391 19.7218 2.72624 -2.60203 -3.14968 +4651 4 52.5877 42.0257 20.5538 -0.625041 0.289898 3.74318 +4652 4 52.305 0.305612 19.0628 -0.905041 -0.864478 -1.55308 +4653 6 1.39118 17.4858 17.9447 -8.50794 14.6458 12.7327 +4654 4 1.24353 17.4779 16.9894 -1.31782 -10.0732 -1.96873 +4655 4 1.47925 16.6123 18.3551 -1.8326 -9.29856 -10.4725 +4656 6 37.8975 19.0277 37.6053 -28.6618 15.029 -11.7184 +4657 4 36.9647 18.7897 37.7838 11.6122 1.96204 1.16191 +4658 4 38.4406 18.4447 38.1174 10.3965 -16.3488 12.6679 +4659 6 26.9855 30.3558 38.071 9.50079 1.40194 -4.36533 +4660 4 26.0886 30.216 37.7369 5.39533 7.19535 -1.12484 +4661 4 27.2954 31.2276 37.7499 -13.0308 -11.5285 -0.168161 +4662 6 20.0885 18.5747 3.04679 -6.02291 21.5949 -15.2672 +4663 4 19.9787 17.7407 3.50085 7.53739 -11.7285 12.3408 +4664 4 20.8981 19.0299 3.33477 -4.38138 -14.9723 0.744253 +4665 6 35.0861 6.94018 4.08702 3.04221 -3.62035 -0.583554 +4666 4 35.6351 7.18342 3.33325 6.4301 -2.1748 -2.62446 +4667 4 34.2564 7.39563 3.93984 -10.6534 0.652929 2.2495 +4668 6 22.2213 37.08 31.2556 -28.1532 13.1327 42.6182 +4669 4 22.1563 36.8958 30.3458 -2.68084 -5.78815 -35.014 +4670 4 21.2899 37.3194 31.5407 35.2494 -6.03647 -12.8067 +4671 6 12.3954 22.364 41.8234 21.4337 26.9075 -8.21443 +4672 4 12.9612 23.1595 41.5956 -22.2624 -27.6618 12.5485 +4673 4 11.7092 22.295 41.1522 0.74395 2.83494 0.343647 +4674 6 43.2331 30.3213 23.157 26.8689 32.5799 1.85734 +4675 4 44.1495 30.0558 22.8796 -21.7207 5.89602 6.32158 +4676 4 43.3514 31.2801 23.4416 -6.45211 -30.9956 -6.78246 +4677 6 16.5257 8.07813 16.6617 -19.4309 -12.5216 11.6481 +4678 4 16.3886 8.34983 15.7476 7.00958 2.01583 -5.14722 +4679 4 17.4107 8.32004 16.9428 8.9294 8.4681 -2.86418 +4680 6 10.0506 8.65043 31.7756 -2.39508 10.2278 -10.4865 +4681 4 10.14 7.97578 32.4103 1.95442 -36.8206 12.1998 +4682 4 10.116 9.39125 32.3649 -0.107045 27.388 0.472024 +4683 6 10.1509 6.49695 25.6483 14.6726 -6.33183 2.00995 +4684 4 9.37694 6.15153 26.0805 -12.3653 -8.75157 5.1154 +4685 4 9.82248 7.1865 25.0601 3.70088 -0.958502 2.30736 +4686 6 49.8668 7.2369 25.5225 -24.0329 9.97804 -6.35029 +4687 4 50.053 6.31696 25.3599 8.14544 -13.6468 -2.92498 +4688 4 50.6696 7.6642 25.7982 18.0374 4.82749 5.17198 +4689 6 18.4641 37.5693 33.932 -1.74635 9.46172 -1.89257 +4690 4 17.7617 38.2474 34.0853 10.1616 -18.2299 -3.47398 +4691 4 18.0542 36.6946 34.0238 -8.30855 4.53024 1.19921 +4692 6 32.1897 34.7964 39.2558 32.2313 -17.5381 13.0656 +4693 4 32.48 34.3381 40.0896 -7.23509 10.7133 -18.5379 +4694 4 31.2879 35.0284 39.3813 -31.6037 5.0658 8.82 +4695 6 49.5304 23.9104 4.45569 25.8701 3.67026 -38.321 +4696 4 49.7808 23.1947 5.01942 4.2809 -18.8946 17.0996 +4697 4 48.8132 24.3493 4.85794 -31.8244 16.1567 21.064 +4698 6 6.0606 24.4992 33.9345 -0.638471 -2.64646 7.7036 +4699 4 6.7001 23.7849 33.7997 2.17947 5.97399 -8.00372 +4700 4 5.47521 24.1274 34.6146 -0.567039 8.82042 -5.77933 +4701 6 1.71497 22.9937 24.1827 2.23241 21.1509 -1.27791 +4702 4 1.62302 23.9425 23.95 -0.486435 -10.8617 3.92094 +4703 4 0.825214 22.7289 24.4403 -5.44701 -4.12175 2.39318 +4704 6 12.4657 16.5565 32.3481 -44.3953 42.3465 -23.9812 +4705 4 13.2256 16.0186 32.4214 25.6927 -27.9273 24.4997 +4706 4 11.8347 16.6394 33.1026 23.5286 -12.3088 -0.369419 +4707 6 21.3722 37.3857 27.9432 8.33623 1.67622 30.3175 +4708 4 21.2745 37.3852 27.0022 -8.47587 6.30229 -26.1478 +4709 4 20.7646 38.0573 28.2974 0.343549 -1.37388 -6.67046 +4710 6 27.2371 40.835 28.8059 -14.5618 2.70883 26.0148 +4711 4 26.5104 41.4636 28.9519 7.17104 -1.72995 -14.6333 +4712 4 27.2442 40.3637 29.6524 5.83721 -3.62297 -8.28664 +4713 6 0.999535 21.7321 13.5318 -29.3194 4.17708 -0.571391 +4714 4 1.85706 21.6318 13.8745 50.1621 -4.04822 5.83187 +4715 4 0.493313 21.4968 14.3164 -12.4374 2.61082 -2.41507 +4716 6 22.3196 2.57547 8.74609 19.5097 -5.43411 17.7027 +4717 4 22.9517 3.10624 8.26305 13.4452 6.72454 -0.92593 +4718 4 21.5477 2.63817 8.2102 -22.9662 -0.14239 -10.9727 +4719 6 29.9886 17.8486 8.24374 -1.93571 4.49032 -2.67939 +4720 4 29.0601 17.6146 8.32603 -5.42798 -1.41354 1.1127 +4721 4 30.4131 17.4547 9.01282 4.29332 -3.23535 5.29369 +4722 6 3.62824 37.7086 25.7053 -21.3362 8.32154 -6.60892 +4723 4 4.42904 37.184 25.8405 -4.94962 -9.47676 -0.42012 +4724 4 2.83762 37.1591 25.4673 21.6133 3.65171 5.88982 +4725 6 26.7972 27.6476 36.3581 -47.4115 -5.5291 12.7506 +4726 4 26.8465 28.2624 35.6306 8.29087 8.74477 -10.4705 +4727 4 25.8218 27.6191 36.6005 30.1762 -0.597939 -6.56813 +4728 6 13.3509 25.3111 38.1214 6.90903 -15.9492 13.2692 +4729 4 13.3459 24.3911 38.4732 0.919555 17.3618 -5.73458 +4730 4 14.144 25.7168 38.5298 -8.43807 -1.25323 -5.48633 +4731 6 49.7161 27.2636 6.73274 -18.8339 5.2299 -32.7408 +4732 4 49.5935 26.3653 6.40806 5.58405 -0.645115 8.82912 +4733 4 49.2001 27.7791 6.04852 15.3529 -4.94049 26.886 +4734 6 39.7451 11.5811 10.2076 8.75523 -9.51322 -11.6408 +4735 4 40.371 10.9447 9.80262 -5.32314 14.1891 9.76509 +4736 4 39.1233 11.799 9.49079 2.50191 2.43793 7.76023 +4737 6 17.4883 24.9894 35.5591 -19.4762 1.01983 7.35275 +4738 4 17.0975 24.7887 34.694 2.72786 0.423626 1.28381 +4739 4 18.4353 24.8575 35.5073 10.004 -2.92602 -7.93295 +4740 6 45.0832 34.9807 31.8277 24.5651 -3.79623 6.38158 +4741 4 44.3095 35.5111 32.0501 -8.6141 -4.27399 -12.5931 +4742 4 44.9123 34.3632 31.1055 -12.5508 0.508806 -0.453023 +4743 6 30.2187 9.89463 31.3271 7.05348 4.55507 6.68413 +4744 4 30.4541 10.7656 30.9635 -3.12777 -8.04008 8.45875 +4745 4 30.1355 10.0083 32.293 1.90576 1.32601 -8.54322 +4746 6 32.3712 9.2149 6.61373 28.8381 -35.7198 -39.9492 +4747 4 32.1726 8.66567 5.78496 5.01502 20.0116 29.9298 +4748 4 31.5547 9.49954 6.96481 -36.3246 12.521 14.22 +4749 6 9.26959 24.9556 35.9161 1.96832 15.842 -17.2096 +4750 4 8.91298 25.4858 35.1726 -0.127744 -15.1166 11.0351 +4751 4 9.85583 25.5957 36.3463 -2.24606 -10.0757 2.02076 +4752 6 40.3298 1.49261 18.8755 10.6299 1.30292 -21.7 +4753 4 39.6194 1.80532 19.3944 -35.8146 17.5344 12.5449 +4754 4 40.7796 0.936194 19.4956 21.1502 -18.4862 6.40423 +4755 6 5.26901 10.6323 30.4328 -1.07618 -0.575959 25.8078 +4756 4 5.0059 11.4532 29.9824 1.00544 3.53991 6.4134 +4757 4 5.36238 10.8297 31.4225 -4.75078 2.46468 -31.0333 +4758 6 25.6472 11.7043 25.6564 -2.85241 -30.912 5.54365 +4759 4 25.9319 12.4737 26.1319 5.23872 14.1859 6.15637 +4760 4 25.9893 10.9537 26.204 -5.41829 19.961 -14.7301 +4761 6 21.91 20.0664 29.7913 -6.2328 1.4725 0.460556 +4762 4 22.5319 20.0532 30.5545 -13.0709 -9.05965 -9.53591 +4763 4 21.5487 19.1817 29.5606 11.8355 8.09924 7.60661 +4764 6 10.008 19.9919 34.5046 11.2891 -12.0839 -11.2138 +4765 4 9.40296 20.4589 35.0806 -5.60052 -0.834193 8.04722 +4766 4 10.0208 19.0442 34.745 -1.06298 11.667 -2.12072 +4767 6 24.6334 10.3662 12.209 5.25257 18.8662 20.0118 +4768 4 24.6941 9.47775 12.5956 1.57271 8.96717 -2.9517 +4769 4 24.9719 11.0034 12.9045 -11.2568 -27.0384 -15.8586 +4770 6 50.4496 28.283 11.5446 48.5969 7.21476 -25.6728 +4771 4 51.3012 28.7385 11.2434 -32.0883 -19.6524 11.3949 +4772 4 50.1145 28.8771 12.2081 -10.2548 6.02908 11.3498 +4773 6 13.9159 27.6234 25.0588 -25.6331 11.4059 -15.4978 +4774 4 13.5005 28.0493 25.83 5.93925 -3.01588 -8.8098 +4775 4 13.4276 28.0022 24.2718 14.6036 -12.4854 23.8457 +4776 6 46.1589 18.6653 40.4078 -23.2184 -0.389309 -10.7846 +4777 4 45.2349 18.5626 40.0761 15.1795 0.391647 5.46432 +4778 4 46.2048 19.5984 40.6658 -0.558864 -5.77386 -4.91212 +4779 6 32.4746 14.176 27.1227 -16.003 2.1806 5.505 +4780 4 31.9042 13.6172 27.6867 7.52463 5.83279 -7.70325 +4781 4 32.1655 15.0897 27.2802 4.78128 -6.53963 -2.41902 +4782 6 14.0556 36.3553 13.3828 19.8073 6.5728 22.6139 +4783 4 14.1017 37.3298 13.5875 -14.1879 -23.5484 -13.1576 +4784 4 13.3212 36.1206 12.8052 -8.41953 14.8686 -5.40295 +4785 6 1.88392 36.5802 21.9963 -4.52806 -9.18778 1.34501 +4786 4 1.78058 36.5165 22.9531 -3.13652 -1.22736 7.08711 +4787 4 2.81062 36.8013 21.8509 3.08344 1.49572 -0.20158 +4788 6 25.283 31.8665 39.7486 -0.0346121 -4.3463 21.3102 +4789 4 24.9491 32.7147 39.4474 -1.97702 6.83441 1.95234 +4790 4 25.5262 31.9404 40.7015 -5.12155 2.92558 -20.0537 +4791 6 6.47988 22.0137 1.28428 -12.6715 -7.61279 -4.66874 +4792 4 5.53909 21.8738 1.48571 10.6555 3.73696 2.93659 +4793 4 6.5727 22.8978 0.916948 1.0061 5.37498 -0.183021 +4794 6 27.6236 25.0404 4.70626 6.00578 18.2896 15.2827 +4795 4 28.5331 25.4118 4.61276 -17.9968 -6.47987 4.19831 +4796 4 27.2352 25.3966 5.54825 13.7859 -6.49357 -18.8943 +4797 6 21.6401 30.9371 41.2305 6.69834 21.9548 -27.1087 +4798 4 21.276 30.3289 41.855 -17.7491 -18.0709 13.8774 +4799 4 21.0024 31.0127 40.4783 8.64888 -5.56942 17.5854 +4800 6 32.355 18.8729 12.7674 13.4209 4.31066 2.75957 +4801 4 31.3956 18.9706 12.835 4.55688 -5.10905 -10.5867 +4802 4 32.607 18.5493 11.8826 -7.53687 3.28724 6.30822 +4803 6 35.6452 19.4617 21.1556 -9.82604 19.2175 8.60555 +4804 4 35.3405 18.5718 21.3708 -2.26659 -3.59924 -3.4629 +4805 4 34.936 20.0876 21.4701 16.8427 -19.1907 -7.36791 +4806 6 27.6904 17.9595 34.0135 2.51947 12.848 9.8691 +4807 4 28.1207 18.371 33.2456 -3.55582 0.0466306 5.59907 +4808 4 28.0719 18.4525 34.7708 -4.77519 -7.99763 -12.3529 +4809 6 34.1913 39.0308 14.8198 -32.2909 7.81486 42.3772 +4810 4 33.7378 38.3849 14.2709 2.40292 -0.641653 -5.60016 +4811 4 33.4938 39.1934 15.5434 31.6198 -1.67931 -26.5413 +4812 6 28.5078 3.47132 33.888 -4.80695 9.04662 2.15546 +4813 4 27.9441 4.2497 33.8725 -11.1427 -2.20885 -1.07295 +4814 4 29.3801 3.85895 33.8332 18.6007 -6.2612 -1.20104 +4815 6 34.9259 32.1312 6.54177 -41.0464 -12.9808 21.9467 +4816 4 34.0171 32.0297 6.98271 38.7419 4.2921 -24.6555 +4817 4 35.5211 32.1736 7.29951 5.76537 -1.35874 -3.25655 +4818 6 31.8896 6.8799 23.5232 0.89208 3.44668 5.58958 +4819 4 32.4231 6.58347 22.7679 -0.16899 1.4285 3.8543 +4820 4 32.2407 7.75715 23.7826 1.29066 -6.24882 -6.25814 +4821 6 18.8559 1.76458 0.828337 -20.5472 23.3683 -17.7838 +4822 4 18.0266 2.11952 0.42761 13.2396 -12.575 3.84382 +4823 4 19.0445 2.38904 1.53279 3.18086 -1.81057 9.578 +4824 6 26.9929 18.9294 11.856 68.8676 -4.65359 -28.5611 +4825 4 27.3133 19.7685 11.4551 -15.5879 -7.28987 7.59546 +4826 4 26.1136 18.988 12.1267 -55.7646 13.8464 15.3945 +4827 6 43.8351 11.1458 18.4443 23.0031 -19.5153 4.50837 +4828 4 43.638 10.8812 17.5537 -13.1544 4.18059 -17.1583 +4829 4 44.5589 10.5175 18.6246 -1.75483 13.9327 9.72942 +4830 6 33.4946 40.5615 37.6755 15.4013 8.76106 -9.33396 +4831 4 34.0096 40.2689 38.4502 -12.4229 -1.46966 -1.83753 +4832 4 32.5786 40.2698 37.7667 -1.95229 -4.85928 9.55413 +4833 6 15.6186 26.7023 39.419 -29.2453 -49.1617 7.39509 +4834 4 15.4971 26.9949 40.3155 1.17426 12.5786 14.7177 +4835 4 16.1446 27.3092 38.9602 29.5915 33.502 -22.8309 +4836 6 4.38071 13.8775 40.883 9.27553 -14.126 -4.37485 +4837 4 5.31782 13.6454 41.0342 -11.8393 4.50398 0.960258 +4838 4 4.04834 13.2497 40.2173 2.13772 10.7877 7.68198 +4839 6 20.1656 10.4005 38.218 10.8779 4.82467 -13.4554 +4840 4 20.4848 10.7245 37.3555 -10.2589 -5.36296 0.708096 +4841 4 20.9923 10.2607 38.6798 -1.28838 -2.71386 11.844 +4842 6 15.1666 19.24 23.8849 4.49083 -8.21488 3.46045 +4843 4 15.3253 20.1347 24.2296 -1.0797 -1.90309 -4.08137 +4844 4 15.0239 19.3391 22.9299 0.969961 5.53483 11.956 +4845 6 47.8934 28.614 15.7995 12.3109 16.1315 8.54118 +4846 4 47.9523 27.7003 15.5425 0.10403 -15.196 -3.00888 +4847 4 48.6265 28.752 16.4246 -6.57835 -5.21115 -6.70139 +4848 6 29.9259 30.9075 18.965 7.62461 4.23841 -1.37457 +4849 4 29.1117 30.4308 18.7732 -7.06282 -5.88302 -2.4339 +4850 4 29.7134 31.8391 18.8515 -2.57834 1.4724 1.74445 +4851 6 11.9338 35.8178 28.497 -7.27451 6.14295 -10.3733 +4852 4 12.5041 35.9802 29.2427 6.70347 11.4983 16.16 +4853 4 12.1847 34.9375 28.2428 -3.53576 -18.0038 -9.26428 +4854 6 29.972 37.8772 25.486 -12.1052 4.73031 -22.3992 +4855 4 30.2553 36.9663 25.6711 3.40868 8.54106 4.83275 +4856 4 30.3747 38.5051 26.0898 8.03536 -1.45294 10.6494 +4857 6 52.6584 28.1048 32.275 31.4311 4.91254 4.04956 +4858 4 52.2473 28.8547 31.8392 -9.38068 2.35947 -3.12986 +4859 4 53.5924 28.4001 32.3224 -6.05351 -9.99886 1.81474 +4860 6 37.0156 40.0823 11.982 15.2095 -8.99172 -8.52195 +4861 4 36.22 40.5624 12.1833 -15.2617 4.79593 6.40041 +4862 4 37.4101 39.8767 12.8402 0.665617 -0.484924 4.09883 +4863 6 16.6662 16.7824 36.4899 -23.6543 20.4081 -13.3107 +4864 4 16.0299 17.4889 36.7962 20.061 -22.8424 -10.9222 +4865 4 16.728 16.9177 35.5139 -3.3638 -0.555369 18.7216 +4866 6 27.9984 4.17668 38.8431 -6.8633 -1.77316 4.22536 +4867 4 28.9161 4.3061 39.1095 4.06977 1.67187 2.70396 +4868 4 28.0368 3.69267 38.0106 -3.95018 -5.40445 -5.6405 +4869 6 28.9057 0.266004 17.7212 -6.10073 29.2375 -5.44551 +4870 4 28.1786 0.88303 17.5246 8.92385 1.95552 -1.67076 +4871 4 28.4447 41.3635 17.8399 -11.0591 -30.1495 5.35559 +4872 6 22.9291 20.1009 26.2737 12.905 2.01461 18.3128 +4873 4 23.6265 20.0378 26.9508 -1.05622 -6.52034 -10.1156 +4874 4 22.4706 20.8929 26.5742 -3.00423 3.39878 -4.61403 +4875 6 49.3993 29.9017 13.433 -6.38025 27.1117 -0.919919 +4876 4 49.1201 30.8275 13.1802 1.84527 -26.9682 8.98406 +4877 4 48.7504 29.5045 14.041 1.51099 8.43883 -0.914593 +4878 6 2.44855 24.8301 7.30401 -10.5471 2.4163 20.698 +4879 4 2.41495 24.6588 8.2845 -1.1432 9.4633 -23.8545 +4880 4 1.72338 25.455 7.1058 6.30785 -9.44609 7.39061 +4881 6 30.3915 26.4508 14.3344 -6.38639 41.9339 41.7386 +4882 4 31.0669 26.3804 15.0403 -0.162406 -14.5956 -15.076 +4883 4 29.932 27.2875 14.6522 8.5071 -34.3491 -22.1885 +4884 6 27.0361 32.5047 3.13805 -13.013 14.5566 5.91638 +4885 4 26.4776 33.1542 3.63465 13.8957 -14.3888 -12.6314 +4886 4 27.3381 31.8882 3.81715 0.997102 -1.94867 -0.811892 +4887 6 34.2693 14.8073 1.28197 14.9869 -24.9335 -24.2287 +4888 4 35.1732 14.4308 1.1613 -12.3133 12.1546 9.27146 +4889 4 33.7818 14.2606 0.617478 5.51233 18.0169 18.4334 +4890 6 30.0243 8.54272 1.33127 -15.3984 1.11418 15.9731 +4891 4 29.9557 9.47917 1.12547 1.89625 5.05184 -1.94546 +4892 4 29.278 8.4251 1.95594 13.4411 -5.55834 -8.66406 +4893 6 42.5535 11.5155 27.7085 15.437 -3.44919 -13.726 +4894 4 42.3225 12.4337 27.8881 -6.79772 -1.02898 5.45325 +4895 4 41.899 10.9203 28.077 -14.0379 1.06089 7.70623 +4896 6 52.4658 39.5603 17.8381 6.64956 -28.6351 -32.0971 +4897 4 51.7413 39.7621 18.3991 -22.9429 13.2738 25.1291 +4898 4 53.1708 40.1592 17.9962 19.9289 22.995 10.0024 +4899 6 33.211 4.92827 31.629 -12.2211 32.167 9.39859 +4900 4 32.8163 5.83971 31.6275 7.84415 -21.2817 2.59476 +4901 4 32.9135 4.52627 30.8083 -0.68235 -2.18314 -5.10952 +4902 6 6.29493 15.9859 18.7482 13.6791 10.985 9.78561 +4903 4 5.93033 16.6016 19.4273 2.88753 -17.718 -13.1605 +4904 4 5.60754 15.3724 18.4768 -10.6912 0.909102 4.08099 +4905 6 8.51749 14.5386 24.6879 -5.02573 1.07483 -2.93277 +4906 4 9.38168 14.4087 25.0828 4.4136 1.3116 3.34168 +4907 4 8.20169 13.6557 24.4566 1.37146 0.850768 1.15416 +4908 6 22.6856 10.1159 32.1347 3.63858 -5.5341 -7.29103 +4909 4 22.4401 11.0127 32.2731 -27.0162 20.0988 15.0061 +4910 4 23.4682 10.3148 31.6383 25.2173 -15.197 -13.8617 +4911 6 11.2884 2.11431 14.6724 -33.0968 -7.95794 -19.898 +4912 4 10.3134 2.08073 14.4479 21.8664 -1.34414 10.3974 +4913 4 11.7152 2.30811 13.8211 9.70644 2.30495 0.939267 +4914 6 44.9099 15.5878 36.2745 25.7257 2.41581 -13.4012 +4915 4 45.0546 15.5553 35.3019 -10.2235 2.9059 20.3658 +4916 4 43.9848 15.4747 36.4307 -17.7944 -2.84066 -0.111047 +4917 6 9.72168 19.0116 31.2214 10.0341 -21.2505 -12.9994 +4918 4 10.5925 19.389 31.3727 0.996524 0.534629 3.32861 +4919 4 9.08651 19.5363 31.6795 -15.0033 12.5653 12.9482 +4920 6 51.9861 7.59179 16.6767 -2.21949 13.5197 0.492591 +4921 4 52.6037 6.8327 16.6765 -16.3843 6.63384 -16.8766 +4922 4 51.5083 7.75362 15.8118 21.6515 -16.4571 17.7861 +4923 6 31.4364 34.7816 36.4086 3.08769 21.0155 -3.2672 +4924 4 31.7704 34.8477 37.2975 8.82098 -13.2304 13.8104 +4925 4 31.3443 35.7177 36.1951 -3.32863 3.82124 -15.3061 +4926 6 4.22848 15.0876 15.3675 -15.1793 -4.71932 15.5862 +4927 4 4.10446 14.9036 16.3273 5.02277 2.80423 -15.2934 +4928 4 5.16622 15.2495 15.2447 10.6913 1.67801 0.337818 +4929 6 47.7535 20.6847 28.0297 3.73811 3.24498 -1.95167 +4930 4 47.6703 19.7739 27.6852 3.21079 12.9013 3.0329 +4931 4 48.3469 21.1738 27.4217 -9.1514 -8.95746 6.26441 +4932 6 15.7983 1.14885 24.4111 -6.64534 16.957 -16.446 +4933 4 15.3695 0.397874 24.8496 -11.2605 5.13601 -9.62176 +4934 4 15.1572 1.72115 23.8957 14.1067 -25.56 23.4483 +4935 6 34.5718 39.7067 40.0668 -5.06722 14.7699 1.92827 +4936 4 34.1159 40.1215 40.7935 -0.0189783 27.8984 7.01187 +4937 4 34.2456 38.8495 40.221 -5.22714 -44.7262 -10.8544 +4938 6 20.1936 32.176 34.4055 -22.5016 27.7868 41.3602 +4939 4 19.6673 32.7687 35.0502 14.2298 -29.0143 -30.198 +4940 4 21.0584 32.1328 34.8407 -2.28869 -2.39527 -4.5293 +4941 6 19.3074 38.5208 11.8317 17.689 14.4135 -2.63233 +4942 4 19.236 37.5914 12.0232 -0.177798 -10.0936 4.99209 +4943 4 20.0172 38.8749 12.4245 -13.7536 -7.85063 -8.99287 +4944 6 6.52955 13.5023 26.836 -16.6143 37.6784 -17.6139 +4945 4 6.084 14.0762 26.1427 18.8957 -21.2062 24.9102 +4946 4 6.49663 12.6281 26.4634 0.197125 -15.4908 -4.14034 +4947 6 23.5952 31.5638 33.3318 1.16311 -12.5666 -5.83621 +4948 4 23.0836 31.562 34.1475 0.610672 3.97154 0.891929 +4949 4 23.5328 30.6432 33.0053 1.46337 8.27478 -1.79938 +4950 6 41.0778 31.9114 16.1974 16.3032 -14.6541 -18.8682 +4951 4 41.8878 32.072 16.7344 -12.1593 -9.44827 -16.6375 +4952 4 41.2894 31.3264 15.4036 6.53327 16.9697 25.199 +4953 6 31.7476 18.8699 19.3483 9.2825 22.1595 5.37598 +4954 4 32.0642 19.7361 19.7036 -9.20895 -19.367 -8.68372 +4955 4 31.4026 18.3831 20.1168 1.10858 -0.37958 -4.48043 +4956 6 10.4875 4.12209 19.3444 6.70816 11.4672 -10.0773 +4957 4 9.70261 4.48263 18.8666 20.7562 -4.21822 -0.723312 +4958 4 11.3166 4.33216 18.8218 -27.5212 -3.06207 15.0001 +4959 6 1.37991 32.4635 19.2846 24.7257 -29.6508 -15.3303 +4960 4 1.97113 31.6954 19.1311 -3.90248 7.07021 19.3035 +4961 4 1.16609 32.6455 18.3731 -9.24935 13.5936 -9.63824 +4962 6 42.8716 16.8513 24.9892 37.8526 -21.8211 -51.5646 +4963 4 42.4398 17.6894 25.0051 -12.6784 17.6471 3.13223 +4964 4 43.4179 16.871 24.1222 -26.4831 0.994324 39.976 +4965 6 45.3183 19.1979 4.10041 6.37956 15.045 3.35342 +4966 4 46.1127 19.7887 4.04575 -15.2131 -7.48775 2.85843 +4967 4 44.6191 19.6898 4.58798 10.0124 -1.75765 -5.61527 +4968 6 29.1291 19.8804 35.7574 13.154 -41.1853 -12.3735 +4969 4 28.6049 20.2559 36.4387 -19.4183 16.2678 16.1743 +4970 4 29.3151 20.5439 35.0927 -1.78114 11.3903 -2.63997 +4971 6 31.9353 21.8377 19.6787 8.2762 14.7684 -3.54893 +4972 4 32.7301 21.8918 19.0885 -22.5823 -4.29925 15.9785 +4973 4 31.6692 22.7774 19.8195 3.83825 -20.8185 -1.08359 +4974 6 39.1936 8.26228 18.8336 -23.7578 16.4079 -2.4793 +4975 4 38.9784 7.343 18.63 -1.41923 -3.63173 -0.882922 +4976 4 38.3593 8.77699 18.6285 24.7505 -17.6369 4.60834 +4977 6 33.27 13.2649 41.2621 -10.1289 -28.0457 11.6457 +4978 4 32.3532 13.5818 41.1472 2.43324 -1.71459 -0.314725 +4979 4 33.2053 12.355 41.6729 1.3348 20.3333 -9.56947 +4980 6 5.93721 29.5458 35.7995 -7.4397 -15.3695 -5.23966 +4981 4 6.3797 30.3135 36.1022 6.42857 23.5026 12.0451 +4982 4 6.51225 29.246 35.0987 1.02237 -6.8727 -9.18458 +4983 6 13.023 34.1764 31.9266 -10.1581 -4.84889 27.419 +4984 4 13.003 33.3874 31.3637 -4.82745 -5.23795 6.11925 +4985 4 12.6053 33.9771 32.8123 10.4055 -1.49763 -26.3146 +4986 6 33.9757 21.8032 17.9969 16.1152 -19.1834 -4.43927 +4987 4 34.6651 21.0941 18.0436 -13.0194 10.1005 -1.31384 +4988 4 34.4424 22.6001 17.7557 11.611 10.6919 -5.33679 +4989 6 35.9777 41.3398 18.1614 -6.56463 -6.11943 -26.9477 +4990 4 35.8856 41.423 17.1648 6.35377 -3.40276 32.4743 +4991 4 36.5823 0.128109 18.4064 3.22136 6.47441 1.04719 +4992 6 34.856 37.6452 30.5972 -0.647303 3.94572 7.36538 +4993 4 35.2577 36.9607 30.0196 0.445186 1.06156 15.4535 +4994 4 34.8848 37.3986 31.5588 5.49281 -5.52744 -23.9922 +4995 6 25.9972 34.4216 4.68589 -10.7784 -9.94602 -21.2075 +4996 4 25.3582 34.53 5.39473 2.66172 5.48603 12.8385 +4997 4 26.8259 34.8497 4.89674 4.47855 8.12742 13.9663 +4998 6 19.0606 33.5662 1.31783 4.31184 23.0948 -29.5486 +4999 4 19.7493 33.0549 1.74461 7.17592 -5.61608 3.87291 +5000 4 19.5019 34.1007 0.592753 -8.94353 -18.7796 23.9626 +5001 6 25.2721 8.22916 8.60038 8.3672 -6.50911 13.4278 +5002 4 25.4774 8.1828 9.55838 -2.37789 7.03817 -10.0574 +5003 4 25.4001 9.14285 8.30246 -0.229164 -0.61302 1.82749 +5004 6 12.8408 19.6874 13.0432 23.1779 -10.767 -3.57874 +5005 4 11.9236 19.9359 13.0109 -16.1394 8.08564 -1.3752 +5006 4 13.3549 20.4875 12.8299 -11.6819 -5.55115 1.76181 +5007 6 53.3458 11.4322 5.81729 13.7919 -26.0181 10.511 +5008 4 53.941 11.999 6.3288 -5.2171 7.54934 -1.97002 +5009 4 52.6156 11.905 5.44666 -11.025 16.6744 -4.72885 +5010 6 9.84401 16.0447 31.1965 1.52473 25.7097 1.4485 +5011 4 9.0725 15.75 30.7245 -12.2986 -10.5074 -10.4763 +5012 4 9.76401 17.0228 31.1974 4.09395 -10.8484 3.46066 +5013 6 25.4337 20.2897 3.31222 -0.0744965 -16.6885 15.2888 +5014 4 25.4502 20.7681 4.1742 1.29774 3.58896 -22.0188 +5015 4 25.617 20.9088 2.59036 0.892976 4.59184 10.0233 +5016 6 20.7687 8.19442 15.6442 -13.8219 -45.5838 -0.24202 +5017 4 20.3131 8.5145 16.4113 -6.16339 18.6345 13.1662 +5018 4 20.3525 7.29833 15.5772 17.5129 18.5489 -8.91575 +5019 6 37.6537 8.61162 9.99803 6.38032 -10.5281 17.8344 +5020 4 37.9174 7.70722 10.2264 -2.01487 8.44182 4.78342 +5021 4 37.3414 8.51532 9.10193 -3.86116 3.7435 -6.65528 +5022 6 50.6588 4.51187 24.2729 -10.1552 -3.70856 6.87258 +5023 4 49.9071 3.88527 24.1971 13.583 4.61791 0.248303 +5024 4 51.4381 4.036 24.5943 -3.42543 -3.47462 2.6777 +5025 6 20.1632 24.8244 34.8962 -12.0105 28.899 -22.2545 +5026 4 19.9486 25.4522 34.1467 5.29317 -18.0262 19.0072 +5027 4 20.331 23.9626 34.5117 -0.31696 -10.3492 -2.27521 +5028 6 30.5785 22.522 11.2467 -2.76969 13.8933 23.9619 +5029 4 31.2526 22.1243 10.7257 13.2932 -13.8734 -17.1472 +5030 4 31.019 23.338 11.5119 -11.6942 5.7798 2.38886 +5031 6 17.322 40.803 8.03266 14.2969 -15.2802 9.14469 +5032 4 17.3696 39.9923 8.55945 -20.3131 5.85274 7.92005 +5033 4 18.1352 40.6655 7.5489 4.4024 9.10004 -19.1526 +5034 6 23.9661 41.0457 26.0803 21.1205 -0.428792 10.5169 +5035 4 24.3123 40.6207 25.2948 17.4674 -5.32369 -4.96192 +5036 4 23.0464 41.0448 25.8953 -36.0489 4.67224 4.09659 +5037 6 9.79449 25.5813 27.216 11.7002 -20.4303 -20.1428 +5038 4 10.1564 25.0129 26.491 -8.57195 17.3601 17.171 +5039 4 10.1924 25.2359 28.0288 -3.53182 0.239058 0.558234 +5040 6 35.2535 29.8267 24.7533 16.8399 6.514 6.92542 +5041 4 34.3962 29.6585 24.3475 -6.29365 6.70405 -5.90439 +5042 4 35.51 30.7547 24.57 -10.2352 -8.20594 -2.77553 +5043 6 2.14051 4.25227 10.5512 -4.35014 2.09559 7.87868 +5044 4 1.87018 4.24401 11.51 4.03105 2.56783 -22.6964 +5045 4 1.48695 4.75313 10.0317 0.0426026 -1.98947 12.7879 +5046 6 43.1755 3.92129 23.5016 -16.6861 -14.9885 0.818311 +5047 4 43.8939 4.14262 22.9078 7.68421 2.83398 -7.81803 +5048 4 42.5577 3.34913 22.9937 11.3891 7.34243 2.48813 +5049 6 18.8996 22.6297 2.43765 22.7339 -13.1014 -2.24121 +5050 4 19.79 22.181 2.40524 -25.7911 11.1615 4.63986 +5051 4 18.7139 22.8085 3.37028 4.18935 -2.21949 -1.21374 +5052 6 20.4908 18.9405 41.5599 0.284845 -17.4141 21.8797 +5053 4 20.1374 18.6064 0.533469 2.69626 22.1818 -33.2143 +5054 4 19.9839 19.6587 41.147 -4.56676 -6.01516 12.1125 +5055 6 26.4163 7.55623 29.1338 1.47231 -3.25042 -11.8229 +5056 4 25.7099 7.08251 28.6481 8.40182 7.03804 13.9135 +5057 4 27.0821 7.71224 28.4448 -4.02075 -2.1597 11.7889 +5058 6 25.6465 35.5679 33.7595 -11.9902 -19.4032 2.16293 +5059 4 26.3374 36.2384 33.6103 2.60319 -14.9989 -6.30077 +5060 4 25.8315 34.6987 33.2841 2.54327 33.8846 12.2934 +5061 6 24.8333 0.493635 8.41989 34.5336 11.5552 47.2955 +5062 4 25.5249 0.302877 9.1499 -35.8013 6.01564 -39.2036 +5063 4 24.7614 41.6068 7.91956 0.436288 -16.6888 -13.1367 +5064 6 17.008 17.3182 3.45493 -26.2706 15.7324 15.4846 +5065 4 16.2426 17.9829 3.53843 29.8189 -30.5055 4.13684 +5066 4 17.1653 16.9244 4.35506 -11.2277 16.1793 -19.3505 +5067 6 40.1827 32.1035 19.3506 13.0539 -5.95213 0.358733 +5068 4 39.8335 31.2604 19.604 -25.4023 -11.2285 12.0125 +5069 4 40.9513 31.7409 18.9215 18.5667 14.352 -9.19942 +5070 6 23.3808 26.7171 6.31746 29.0762 21.4976 14.3842 +5071 4 24.13 27.3908 6.46801 -30.1018 -19.5893 -7.69607 +5072 4 22.7349 27.0723 5.68536 3.11778 6.18165 -0.6273 +5073 6 28.6527 28.5112 1.41186 -10.6623 -30.4119 4.69741 +5074 4 28.683 29.4458 1.20631 15.125 4.74584 -7.70298 +5075 4 29.5288 28.0803 1.2704 -12.115 26.7011 1.44139 +5076 6 12.0438 6.3157 14.0384 -8.70244 -3.06108 -4.52058 +5077 4 11.2798 6.1721 13.4181 27.4537 -0.215786 8.28745 +5078 4 12.8925 6.19521 13.5554 -16.057 2.9292 1.41242 +5079 6 20.1243 33.7022 32.0954 -30.4257 7.53408 -8.19993 +5080 4 20.1371 33.1054 32.8412 7.6416 -5.80656 10.7415 +5081 4 21.0197 33.8732 31.8382 18.9224 -1.8204 -0.321518 +5082 6 12.0625 33.3632 34.5388 -0.325915 -41.4281 -23.9157 +5083 4 11.5602 33.8727 35.1697 -10.674 0.646784 10.687 +5084 4 11.6234 32.4653 34.3673 14.5179 34.5198 8.14895 +5085 6 6.00279 22.2605 25.0501 2.06163 -11.5991 79.3474 +5086 4 5.88194 22.3996 24.153 -16.4068 14.8809 -57.8418 +5087 4 5.25089 22.6367 25.5854 16.5977 -6.05374 -22.2773 +5088 6 28.8802 9.48792 11.0269 30.0757 -27.8021 5.60101 +5089 4 29.142 10.167 11.6644 -15.2392 1.2069 -12.766 +5090 4 28.0854 9.70897 10.5587 -15.7703 15.13 -3.00542 +5091 6 25.9783 31.1564 24.8742 0.212243 -23.2246 11.0271 +5092 4 26.2703 31.9474 24.4305 5.78101 9.73635 -10.8861 +5093 4 26.5948 30.4205 24.6499 -9.08002 14.2421 1.82694 +5094 6 17.4069 22.6321 26.9528 -11.8732 29.0046 13.506 +5095 4 17.1509 23.4374 27.5137 11.798 -28.7792 -23.9739 +5096 4 17.5283 21.9112 27.5803 0.671776 -8.09241 2.21186 +5097 6 30.9731 17.6144 1.64569 13.582 26.8251 31.1357 +5098 4 30.2123 17.6859 1.07719 -13.0538 -2.75682 -13.3747 +5099 4 31.0067 18.4528 2.19078 1.05257 -25.2161 -14.5596 +5100 6 35.2833 9.73343 11.2271 -16.277 -4.62114 -26.0747 +5101 4 34.627 9.45499 10.5137 29.3374 5.62349 25.4867 +5102 4 36.1567 9.37366 10.9701 -6.28276 0.375521 -3.01301 +5103 6 12.0057 10.8077 4.27601 -12.2512 -1.40581 -7.43609 +5104 4 11.4458 10.5898 5.05281 2.39288 0.24657 -15.6405 +5105 4 11.51 10.5288 3.46435 7.55978 2.35404 20.8087 +5106 6 52.9546 23.1284 7.66438 3.19212 11.9041 -9.13647 +5107 4 53.8155 23.0936 7.22037 1.72331 -6.21969 -0.472682 +5108 4 52.7997 24.0739 7.82392 -0.633169 -8.94194 3.43433 +5109 6 27.374 5.80114 23.1096 7.51778 12.7335 11.6917 +5110 4 28.1753 5.52132 23.6349 -22.415 18.9583 -13.4562 +5111 4 27.3645 6.79042 22.9959 5.3793 -33.2455 5.89418 +5112 6 22.7689 37.6996 15.5372 -5.91943 -7.67105 33.7333 +5113 4 22.8436 37.842 14.6084 2.14719 5.97904 -25.5056 +5114 4 23.2999 36.9284 15.7907 -0.822855 1.46565 -2.93441 +5115 6 30.5901 30.1355 39.7465 -8.92084 9.99629 -19.6672 +5116 4 30.0839 29.6315 39.0953 -1.54922 -9.94816 6.16305 +5117 4 30.5761 31.0154 39.3281 8.00114 -4.73058 9.29019 +5118 6 26.5152 14.8694 29.9646 3.93344 -0.205179 -3.29595 +5119 4 25.7559 15.3094 30.3103 -24.5604 12.1261 -1.41502 +5120 4 27.0839 14.9289 30.718 22.1413 -5.57177 12.178 +5121 6 9.52543 19.5487 37.4182 -4.93509 -3.75546 7.04348 +5122 4 8.56858 19.5373 37.6772 20.7537 10.8584 -9.00922 +5123 4 9.7741 20.4052 37.0166 -14.5013 -9.56436 9.93265 +5124 6 0.91928 14.8658 2.69601 -17.5095 9.99019 63.3715 +5125 4 1.47581 15.1737 2.02419 28.2707 8.36374 -43.6031 +5126 4 1.18821 15.4309 3.47389 -7.04008 -21.0896 -18.5042 +5127 6 46.427 27.1287 41.5945 43.2461 -1.33556 -25.8044 +5128 4 47.402 27.2052 41.2817 -46.4011 -2.64418 15.4668 +5129 4 46.0299 26.5803 40.8989 0.996959 5.24299 8.87294 +5130 6 47.678 23.0562 21.3872 5.44089 38.3346 6.01366 +5131 4 46.9403 23.2179 20.8133 -13.997 9.90145 -6.64011 +5132 4 47.7418 22.1285 21.385 8.56341 -43.7487 4.99103 +5133 6 39.8587 22.235 3.08723 2.37939 -15.5871 -9.21378 +5134 4 39.0088 22.2526 3.53641 -4.44104 7.43329 4.08383 +5135 4 39.9535 21.2857 2.86173 -0.917299 22.2801 6.61021 +5136 6 14.9853 14.9328 33.4647 9.90785 18.6887 5.96998 +5137 4 15.4024 15.8269 33.5858 -13.0369 -24.3412 -0.758701 +5138 4 14.5599 14.6915 34.3048 3.28451 6.61064 -6.43534 +5139 6 27.3302 11.4834 31.9317 -27.4366 -15.9755 21.8219 +5140 4 26.9982 12.0952 32.5883 -9.79098 -5.70708 8.51591 +5141 4 28.0752 11.9422 31.6406 46.9031 18.536 -28.2392 +5142 6 36.7579 7.97089 7.62034 -1.24967 -18.9477 -14.6485 +5143 4 35.954 7.42009 7.70022 6.4697 6.94413 -3.0671 +5144 4 37.4142 7.36122 7.22008 -3.07725 6.9494 1.66736 +5145 6 49.4451 9.66335 18.2174 -4.20907 -17.0946 -5.32386 +5146 4 50.1075 10.0642 17.6138 -11.2883 10.4151 20.0604 +5147 4 49.0937 10.2089 18.9473 16.8995 10.9543 -13.1485 +5148 6 27.0353 33.866 10.7555 -3.61813 20.4819 39.0174 +5149 4 27.1089 33.3944 9.9425 -11.0368 -7.55411 -28.9907 +5150 4 26.1735 34.332 10.8422 4.28798 -12.7598 -13.2634 +5151 6 11.1949 37.4624 6.84871 0.36549 -16.8746 15.3404 +5152 4 10.8648 38.3395 6.66289 0.465253 11.7734 -2.90488 +5153 4 12.1583 37.5341 6.85599 1.64848 0.115814 -1.2743 +5154 6 19.2537 19.4156 21.9114 -15.7985 8.22585 33.6704 +5155 4 18.5515 19.3251 21.2863 -16.3583 -5.26309 -15.3133 +5156 4 20.0646 19.323 21.4355 25.7859 -3.53787 -14.4318 +5157 6 54.4972 2.91444 22.5674 41.6328 11.7794 25.4635 +5158 4 54.323 3.09449 21.6644 -16.7292 4.15243 -34.296 +5159 4 0.405558 3.31869 22.7045 -24.6299 -12.807 4.19326 +5160 6 45.0583 10.8549 24.2301 5.83399 20.0221 21.0618 +5161 4 44.4296 11.5751 24.1426 -7.03973 -3.51443 -9.4179 +5162 4 45.6095 11.2138 24.9523 4.1225 -19.1196 -10.3672 +5163 6 14.387 34.402 24.7643 -0.614961 -5.50567 -8.46915 +5164 4 14.802 35.2302 25.0278 -0.621724 2.17228 4.67692 +5165 4 14.8142 34.1913 23.9221 -0.527667 -3.77388 -2.27373 +5166 6 50.586 17.557 4.30707 17.1275 -18.9627 18.6811 +5167 4 51.3126 17.9927 4.759 8.45418 -3.82203 7.11351 +5168 4 50.1863 18.2804 3.88376 -26.598 27.5468 -24.7799 +5169 6 14.9317 33.3337 34.1113 -12.3404 20.8418 56.9019 +5170 4 15.0455 32.9404 33.2912 5.44957 -23.8922 -53.334 +5171 4 14.0148 33.1563 34.3942 8.12215 6.97131 -5.23034 +5172 6 20.8706 33.5768 38.9143 15.1188 7.04694 -15.6549 +5173 4 20.7999 34.008 39.7578 -2.44584 7.66125 17.1111 +5174 4 20.3826 32.7659 38.9944 -10.1095 -18.4284 -0.973943 +5175 6 7.78494 4.73961 26.7587 18.7098 -5.63937 13.378 +5176 4 7.2181 5.0845 27.4506 -5.7435 6.37459 2.19378 +5177 4 7.246 4.75931 25.9687 -5.82922 -1.99593 -5.70414 +5178 6 9.28281 21.4851 22.3014 51.087 14.0475 -25.6174 +5179 4 8.74732 21.9732 21.6886 -31.0609 5.1079 -5.58489 +5180 4 10.1706 21.7227 21.8793 -22.1752 -18.3044 28.8298 +5181 6 20.5441 38.2146 8.8638 -2.83914 11.917 26.817 +5182 4 20.3663 38.6401 9.7626 4.81036 -21.6973 -30.7816 +5183 4 20.4013 37.2533 8.94236 -1.07384 9.24152 7.62946 +5184 6 30.1053 39.0795 30.7451 -13.6764 41.2724 28.6819 +5185 4 30.3998 39.946 31.2193 -9.10868 -42.8123 -24.766 +5186 4 29.1169 39.0706 30.8728 28.3121 -0.882933 -5.94109 +5187 6 16.0486 22.0268 24.5039 34.2787 3.60452 0.906339 +5188 4 16.7735 22.0671 23.8432 -14.3833 -3.87047 -0.289875 +5189 4 16.5419 22.3002 25.3044 -14.2176 -3.36187 3.5873 +5190 6 5.74232 29.2062 14.4594 -18.34 10.8061 -32.1404 +5191 4 6.48422 28.7094 14.7814 11.5218 -3.49899 17.506 +5192 4 5.24211 29.6259 15.1721 5.10135 -5.91064 9.04276 +5193 6 28.0673 3.08827 25.2267 -6.08854 1.42804 12.0746 +5194 4 28.6661 3.71086 24.7756 -7.19123 -0.840207 10.3279 +5195 4 27.7106 3.5203 26.0449 13.0908 -0.523763 -20.3567 +5196 6 45.9319 29.2971 31.4223 -7.33073 21.7818 28.5056 +5197 4 45.7264 28.738 30.6765 -12.0419 -4.51403 -16.7723 +5198 4 45.1872 29.9464 31.611 20.2512 -24.9239 -13.0948 +5199 6 11.2178 22.8398 36.7928 3.83605 7.6889 -19.1741 +5200 4 10.7288 23.4227 36.1801 1.54849 -6.36416 6.79315 +5201 4 12.0227 22.5824 36.3 -5.92076 -0.954096 11.0422 +5202 6 18.9236 40.1387 39.9284 -8.72712 -15.4473 12.674 +5203 4 19.137 39.1923 39.9727 -1.01676 1.76774 -7.47997 +5204 4 18.926 40.4024 40.8597 -1.95632 5.76083 -1.10583 +5205 6 23.5567 26.0801 21.2876 -20.8354 -5.58511 20.4095 +5206 4 22.8283 26.6117 20.9473 7.44123 1.31497 -7.03875 +5207 4 23.1869 25.6705 22.0991 12.7429 3.57595 -14.6326 +5208 6 16.8309 5.38685 15.8596 17.5735 -24.6285 20.3591 +5209 4 16.4468 5.29371 14.9868 -10.6119 14.9975 -0.930521 +5210 4 16.6163 6.1995 16.3389 -7.69088 7.65746 -13.895 +5211 6 12.049 26.6129 14.9962 1.83385 5.07399 -16.0821 +5212 4 11.6864 25.936 15.5307 6.55853 -24.3886 27.1256 +5213 4 11.2609 26.839 14.5085 -0.894459 16.8406 -16.785 +5214 6 14.3334 41.4222 2.37421 26.0216 21.5484 -18.2857 +5215 4 13.7051 40.9662 2.90199 -22.7144 -12.1023 21.977 +5216 4 14.3738 0.426145 2.71152 -4.41702 -11.6567 2.07407 +5217 6 50.4009 35.8582 9.31454 24.1561 17.2373 -12.1424 +5218 4 50.8168 35.8748 8.42953 -10.1576 -5.67977 3.83986 +5219 4 50.8977 36.5714 9.7704 -11.7974 -14.2445 3.10197 +5220 6 11.3695 22.6672 26.8678 6.20997 3.92483 11.2558 +5221 4 12.2048 22.3333 26.5164 -4.88328 -1.76893 -0.685046 +5222 4 10.6892 22.391 26.2565 -8.40373 -4.36232 -8.95219 +5223 6 8.45148 34.5593 21.2814 -25.9919 -59.0281 13.1791 +5224 4 8.04792 35.0446 21.9998 -0.548909 12.0582 7.93151 +5225 4 8.02348 33.6171 21.3881 27.3669 48.26 -12.6189 +5226 6 9.41918 8.68911 24.4735 -32.1109 22.232 -11.1027 +5227 4 8.45415 8.80658 24.2608 22.5553 -3.45738 3.03744 +5228 4 9.54271 9.26889 25.2379 6.1219 4.18012 4.13063 +5229 6 32.6166 22.3351 34.507 3.90791 9.0503 -27.7323 +5230 4 32.5036 23.1955 34.0662 0.599489 -5.17288 -1.28756 +5231 4 32.8196 22.6091 35.3861 6.87298 3.84758 30.2519 +5232 6 26.7427 26.1702 7.11338 18.0622 8.0778 -11.4877 +5233 4 26.0574 25.7087 7.60312 -9.51312 -3.43645 7.19196 +5234 4 26.4504 27.0916 6.97179 -2.60416 -16.0173 4.37043 +5235 6 33.9976 11.9299 3.97475 -1.16308 1.75568 6.69865 +5236 4 33.7915 11.6388 4.87314 3.4696 4.99202 0.68255 +5237 4 33.8545 12.8906 3.99294 -0.306808 -3.71184 -1.40707 +5238 6 21.4819 20.9256 37.2108 -8.76322 20.972 13.918 +5239 4 22.36 21.3309 37.2026 5.25525 -6.97128 0.105034 +5240 4 21.5739 19.9858 37.0637 7.9716 -15.2147 -3.23728 +5241 6 18.467 41.0278 0.654954 -19.554 -29.5721 -12.8619 +5242 4 17.5024 41.1258 0.530294 8.77033 6.01734 2.0842 +5243 4 18.8042 41.8885 0.845086 4.40915 26.8371 2.49279 +5244 6 41.3548 41.7118 25.1844 12.9409 14.5374 -0.392323 +5245 4 40.9222 40.8883 25.4041 -6.90081 -12.2223 3.22908 +5246 4 41.5202 41.6634 24.2378 -1.56977 -0.361026 -1.444 +5247 6 27.6369 28.1312 3.93858 39.9773 31.9241 -60.8173 +5248 4 27.7577 28.1455 2.91253 -1.05119 3.80663 52.0412 +5249 4 26.945 27.5412 4.09124 -36.8498 -31.9254 8.70709 +5250 6 18.2839 10.5111 31.4966 0.533258 -0.0130678 0.979798 +5251 4 17.4029 10.1636 31.5665 -10.6602 -13.9647 -0.00296819 +5252 4 18.1106 11.4466 31.5267 10.9856 11.4938 1.12981 +5253 6 11.3036 37.9694 14.764 4.77413 -10.0896 11.5971 +5254 4 10.7874 37.239 14.4221 -9.53089 5.23111 -9.63971 +5255 4 11.7579 37.5414 15.5118 -2.30342 16.6377 -5.07599 +5256 6 0.816524 18.1414 27.5647 20.1272 -0.3628 -0.469578 +5257 4 0.17179 17.4415 27.469 -11.396 -5.37013 -1.78049 +5258 4 1.63281 17.6507 27.785 -7.45447 11.2502 -1.88757 +5259 6 36.8008 10.7378 20.295 8.4208 9.86458 8.47872 +5260 4 36.1948 10.0642 20.0001 -9.44027 -8.16387 -5.04241 +5261 4 36.5983 10.8279 21.2363 1.65531 0.40354 2.85938 +5262 6 47.4201 25.5213 8.04394 8.74054 5.57223 -13.14 +5263 4 47.3566 25.6372 7.0634 -2.71671 -4.96685 23.4826 +5264 4 46.5708 25.2582 8.40304 -6.39129 0.734124 -5.55138 +5265 6 13.9238 35.1275 16.0037 32.5083 18.1998 3.59786 +5266 4 13.2022 34.5755 16.1957 -32.489 -30.3694 18.6715 +5267 4 13.7597 35.4303 15.121 4.25156 9.41728 -20.5426 +5268 6 29.562 35.3734 16.1776 -35.0835 -2.07929 -8.00281 +5269 4 30.2224 34.9599 16.7245 13.9673 -5.91711 9.2078 +5270 4 28.7051 34.8863 16.2926 25.5199 12.926 -4.35301 +5271 6 29.4722 25.8866 32.4187 14.354 2.72026 -23.1845 +5272 4 28.9025 25.7608 33.1796 -14.4011 -9.23541 2.43376 +5273 4 29.1922 25.3818 31.6086 -3.9853 6.0929 23.1903 +5274 6 24.1343 2.13601 25.4438 45.8363 12.8335 -27.0328 +5275 4 24.6226 2.81425 24.8647 -23.4035 -21.9591 22.2831 +5276 4 24.7019 1.32842 25.3981 -18.0817 13.4017 1.18969 +5277 6 4.54354 34.4275 19.14 11.1292 -12.0398 21.377 +5278 4 4.4735 34.5954 18.1883 -15.738 1.03246 1.7136 +5279 4 3.71635 34.4131 19.6775 9.89222 2.06937 -18.6971 +5280 6 10.1248 17.2257 14.3121 -1.66581 -5.60367 -9.60454 +5281 4 10.2583 17.5937 15.1679 8.8306 2.43924 21.0325 +5282 4 9.4989 17.8227 13.9164 -6.75609 1.38519 -13.487 +5283 6 21.4392 41.7587 34.6855 22.2624 7.769 -11.2018 +5284 4 21.5032 41.1211 35.405 -13.4071 -7.19641 7.36579 +5285 4 20.544 -0.0182627 34.3462 -4.72666 -12.2957 11.4101 +5286 6 36.1543 24.108 12.5954 -4.82194 -9.49577 -8.67068 +5287 4 35.691 23.694 13.3698 5.25066 1.62288 -23.6525 +5288 4 35.776 23.8018 11.7194 2.97337 4.42231 26.8685 +5289 6 49.5838 18.601 19.9434 7.37368 0.836531 -4.03301 +5290 4 50.0063 19.3607 19.4891 -2.40205 -12.3461 5.19746 +5291 4 50.2865 17.9356 20.0577 -3.44895 8.52353 -2.14521 +5292 6 1.26001 7.05318 14.4907 38.3056 -26.8237 -27.7837 +5293 4 1.8201 6.82299 13.6677 -23.9217 11.4061 34.9177 +5294 4 1.48256 6.35829 15.148 -4.21477 12.5307 -9.57675 +5295 6 12.7431 22.7759 31.2417 -21.5742 -17.6245 -17.2109 +5296 4 12.7068 22.0167 30.6251 -0.189583 12.5272 11.0438 +5297 4 13.6543 23.0267 31.2833 20.8009 4.17698 1.04357 +5298 6 8.18693 18.6259 27.8062 12.2535 -2.56913 -7.18349 +5299 4 8.40416 17.6764 27.919 2.05523 15.8207 -2.89848 +5300 4 8.90605 19.0032 27.258 -7.77238 -10.2714 7.52916 +5301 6 52.132 28.0244 15.3085 -5.0475 -8.46487 8.97907 +5302 4 52.2845 27.4141 14.5747 1.7297 4.34316 -0.517396 +5303 4 52.1194 28.9169 14.9336 2.1814 -6.82244 -4.33507 +5304 6 52.6909 21.916 10.0977 -8.33066 3.09691 2.06611 +5305 4 53.4463 22.3007 10.5387 10.5159 5.84972 4.87058 +5306 4 52.7807 22.2562 9.19728 -3.40401 -0.944397 -1.81328 +5307 6 22.3502 5.78024 2.67711 -1.19821 4.70475 8.9403 +5308 4 22.3462 5.61537 3.63751 1.98719 -8.03511 -7.01348 +5309 4 22.5962 4.95479 2.25163 2.53332 -12.0932 -0.158426 +5310 6 15.4205 16.2192 21.8867 5.02822 24.0999 -40.4778 +5311 4 14.4784 16.2102 22.0595 -10.022 -3.20892 10.2198 +5312 4 15.4767 16.6809 20.9929 2.09736 -16.6333 30.6862 +5313 6 28.7089 41.2927 33.91 5.52796 3.54283 5.25404 +5314 4 28.727 40.4953 34.4564 -2.79359 -2.24742 -0.170863 +5315 4 27.7951 41.4466 33.6263 4.57527 -2.88437 3.84631 +5316 6 9.01739 31.2727 18.2059 -18.1749 -3.84142 11.7815 +5317 4 8.98151 32.2312 18.3694 0.025829 -3.44513 1.18933 +5318 4 8.52849 30.7949 18.9304 13.8496 11.5721 -17.6376 +5319 6 20.5529 20.3981 18.1799 -10.2473 -3.12886 -8.71499 +5320 4 21.0329 20.6151 18.9854 0.125323 4.65459 7.73128 +5321 4 19.8496 21.0773 18.075 13.4895 -10.4913 3.92819 +5322 6 53.9703 14.7072 37.8312 5.01214 -4.5628 8.74013 +5323 4 53.4666 15.4974 37.9319 -5.56379 24.6001 14.4542 +5324 4 53.6093 14.375 37.0321 1.20033 -18.5897 -21.23 +5325 6 28.9035 15.3885 18.8586 45.4636 -15.1916 -0.680493 +5326 4 29.8469 15.0873 18.5932 -41.6456 12.1347 6.71251 +5327 4 28.9115 15.3505 19.8299 -3.5302 1.25595 -2.12016 +5328 6 2.00256 25.8212 18.9096 3.72723 11.471 14.7099 +5329 4 2.26458 26.6216 18.4327 2.14682 1.88771 -0.892997 +5330 4 1.76414 25.179 18.2501 -5.23937 -11.562 -15.1322 +5331 6 53.2507 40.704 24.2965 8.91441 12.4597 1.37217 +5332 4 53.4683 39.7911 24.0958 -2.511 -10.6834 -0.444896 +5333 4 54.079 41.1598 24.0633 -8.96863 1.63956 3.52407 +5334 6 47.5231 32.0042 22.8531 -14.3462 4.46803 -6.08063 +5335 4 47.3408 32.7709 23.4273 6.00779 -4.56073 2.25025 +5336 4 48.2766 31.5253 23.2067 4.67997 4.39959 7.43042 +5337 6 24.6197 26.1463 33.0089 -12.4366 -5.18424 3.68853 +5338 4 24.4183 25.6868 33.835 -4.3875 -0.159577 -1.83724 +5339 4 25.4547 26.5812 33.1385 10.0429 5.3772 -3.83199 +5340 6 21.3442 17.0884 39.4824 -9.75867 4.42788 -12.86 +5341 4 22.0786 16.6105 39.8509 9.0034 -0.419098 8.66004 +5342 4 20.9617 17.649 40.1682 3.71874 -0.284678 5.70811 +5343 6 11.0324 40.4486 17.0358 15.7971 -30.8577 -26.0801 +5344 4 11.6842 41.1185 17.2103 4.65986 12.9737 2.4903 +5345 4 11.491 39.8695 16.3608 -26.1319 15.9634 25.4848 +5346 6 20.3416 21.2702 39.8615 -24.9835 10.9638 22.3655 +5347 4 20.689 20.9793 39.0389 13.9219 -9.37305 -28.7546 +5348 4 21.0638 21.2843 40.4958 4.25493 1.29328 -0.298347 +5349 6 2.11091 29.6941 22.5934 -5.9509 -23.8702 -11.6938 +5350 4 1.45034 28.9715 22.5035 1.67869 13.3355 3.97539 +5351 4 2.94117 29.2559 22.3631 0.0654014 9.01208 -1.60678 +5352 6 36.7558 30.2897 35.4506 24.3729 -18.3256 16.5828 +5353 4 36.1768 30.1398 36.2224 6.47664 5.98183 -7.75951 +5354 4 37.6324 29.8684 35.7011 -26.9845 14.5763 -5.36474 +5355 6 12.9471 4.31284 37.9204 -6.90268 -11.166 6.10722 +5356 4 12.3078 3.59731 38.1765 12.7034 25.1114 3.17689 +5357 4 12.7446 5.19856 38.3152 -2.40344 -19.0082 -2.01981 +5358 6 38.3332 5.26794 18.4655 -19.3496 19.9027 -29.1997 +5359 4 37.4721 5.17942 18.8804 2.72791 -1.29988 8.64573 +5360 4 39.0241 5.01488 19.0552 15.587 -10.1496 24.0772 +5361 6 10.4858 9.23289 21.7404 -25.2332 -4.10139 2.16313 +5362 4 10.1465 9.25623 22.657 12.6022 -3.18555 -3.91704 +5363 4 11.447 9.27854 21.7188 5.40032 0.87934 7.2107 +5364 6 0.505771 41.0407 17.3245 -0.427706 37.3637 0.906459 +5365 4 1.03474 40.3115 17.5973 10.8601 -24.0642 8.3812 +5366 4 1.07952 41.8285 17.484 -10.202 -14.0113 -5.73388 +5367 6 4.10283 5.07754 6.43738 -38.2782 -14.6693 -26.7901 +5368 4 4.80956 4.44559 6.48511 17.8781 -6.62955 4.00539 +5369 4 4.33824 5.81877 6.9517 16.1672 26.1823 21.8329 +5370 6 11.4353 25.4218 0.164599 -6.84764 4.42394 -1.26617 +5371 4 11.3082 26.3017 0.56247 4.23965 -3.25035 1.30302 +5372 4 12.32 25.1006 0.40702 -4.64442 7.63092 -0.276853 +5373 6 7.41885 21.5502 8.10769 10.495 -13.722 -26.2993 +5374 4 7.61759 21.2522 7.17802 -11.0567 9.56016 28.8323 +5375 4 8.26229 21.8826 8.44859 -7.90548 -1.09713 -4.6635 +5376 6 47.5869 16.3678 25.2584 -15.0789 15.5873 -32.807 +5377 4 46.6352 16.1327 25.0388 32.9447 8.00435 6.4503 +5378 4 47.9767 16.8704 24.4584 -11.2605 -20.3751 33.7323 +5379 6 30.9209 19.4939 39.8451 -11.8548 28.7526 -24.1689 +5380 4 31.8555 19.5183 40.0202 17.1254 -10.6903 10.4692 +5381 4 30.8076 20.3562 39.3598 -8.87252 -26.4956 11.5622 +5382 6 20.3775 24.0331 39.393 16.2123 32.2964 -6.62361 +5383 4 19.46 24.2872 39.3788 -17.3162 -0.971439 2.40317 +5384 4 20.4139 23.0995 39.5119 -7.32592 -29.4126 2.4841 +5385 6 45.906 21.2665 41.1719 -24.2736 -11.4825 -0.885762 +5386 4 46.5804 21.1569 41.8486 15.7955 10.6383 -1.5802 +5387 4 46.0859 21.9477 40.5132 15.7742 6.36757 6.57249 +5388 6 32.5682 28.1996 30.46 3.6658 -10.99 6.0107 +5389 4 32.938 27.299 30.6104 -6.7941 21.8776 -2.09353 +5390 4 33.2105 28.8285 30.8344 -2.85996 -8.65293 -4.24176 +5391 6 18.0144 1.30598 27.0418 -16.6632 -1.71712 -0.445992 +5392 4 17.1007 1.69106 27.0468 26.0213 -5.17059 4.63351 +5393 4 18.4653 1.60291 27.8546 -9.34219 2.14994 -8.02835 +5394 6 39.3706 24.9704 21.8707 -3.8719 -7.6304 -3.05608 +5395 4 39.4638 25.9303 22.0078 -2.06007 -5.24545 2.56571 +5396 4 38.5004 24.7369 22.2528 8.08795 9.92494 -4.1564 +5397 6 33.5838 21.3134 22.0984 8.18441 -4.13225 6.82001 +5398 4 32.7138 21.3502 21.682 2.4933 6.37883 -5.99313 +5399 4 34.1113 22.092 21.8324 -12.1677 -4.37971 -1.53996 +5400 6 40.113 14.9986 15.7558 -14.3933 -54.3129 -47.4443 +5401 4 39.335 14.6192 15.2293 31.4969 18.6384 20.9479 +5402 4 39.7901 15.7154 16.2477 -17.7573 36.9578 24.811 +5403 6 32.6916 17.9228 6.36161 -9.89813 9.73379 -21.0853 +5404 4 32.6423 17.3002 7.0662 1.70901 -17.6566 26.5232 +5405 4 32.2464 17.4542 5.63975 -0.790726 3.03073 -5.51736 +5406 6 50.4678 15.9334 31.144 -39.7004 -26.5385 31.9374 +5407 4 51.253 16.1743 30.7093 39.9028 11.8107 -24.2063 +5408 4 50.5343 14.9829 31.3801 -1.18751 16.0768 -7.78774 +5409 6 23.825 29.3336 31.6412 17.8706 -6.79638 -8.14744 +5410 4 23.7507 29.695 30.7549 -4.03414 2.57591 0.878238 +5411 4 24.7016 28.8907 31.6365 -14.4802 6.46497 6.02506 +5412 6 25.0497 41.6479 38.28 3.49637 2.98657 -6.73496 +5413 4 25.6848 41.2957 37.6072 -14.3525 10.6226 12.6055 +5414 4 24.5759 0.544247 37.957 10.7828 -14.7666 -1.7986 +5415 6 14.3338 25.4719 8.00129 -34.0608 -17.9542 9.33499 +5416 4 15.0375 25.807 7.49197 32.7442 17.1809 -19.3974 +5417 4 13.7504 25.049 7.33286 9.67269 6.09785 11.4563 +5418 6 17.2157 20.7463 5.33337 -33.6161 12.1619 46.6806 +5419 4 17.4746 20.2104 4.61987 19.6997 -12.8632 -39.6831 +5420 4 17.6039 21.6267 5.33982 9.69266 2.06371 -12.0346 +5421 6 18.8632 10.9532 23.7128 -6.45661 -28.7698 -18.1749 +5422 4 18.5024 10.4645 22.9505 4.54871 -4.25462 9.96764 +5423 4 18.7195 11.8343 23.4273 2.43458 32.1183 3.28403 +5424 6 7.79185 41.3929 11.0465 3.42517 6.73563 9.75028 +5425 4 8.03468 40.5075 11.3396 -5.29569 0.405018 -3.04036 +5426 4 8.54504 0.0288503 11.3371 -5.83581 0.184768 -2.76634 +5427 6 48.7029 23.1861 34.0656 -21.7207 -4.36764 -18.9996 +5428 4 48.0685 22.9631 33.3267 17.6914 7.49561 22.5851 +5429 4 49.5647 23.2306 33.645 9.38657 -0.0360042 -3.96825 +5430 6 53.7171 23.5593 15.3279 7.98903 18.1369 9.52531 +5431 4 53.9889 24.0987 14.5512 -16.5338 -16.4319 -0.0123194 +5432 4 53.1679 22.8017 15.1046 0.0193492 2.24596 -12.2178 +5433 6 22.2331 5.62812 9.84443 -1.57081 2.06392 2.32933 +5434 4 21.8309 4.81719 9.48029 9.17546 11.008 0.0652314 +5435 4 22.6135 6.1669 9.11622 -10.9942 -17.7486 8.8339 +5436 6 33.6597 8.39756 9.07438 12.888 -3.30103 7.28088 +5437 4 32.9598 8.97334 9.38893 -12.3292 7.33717 0.65351 +5438 4 33.4682 8.16911 8.16186 -5.09418 6.09353 -6.44604 +5439 6 47.3119 37.7194 20.3363 21.5156 22.744 3.03657 +5440 4 47.6473 37.5407 19.4464 -9.46862 -8.33692 4.35957 +5441 4 46.6883 37.0359 20.5464 -12.6113 -19.4741 -3.99141 +5442 6 30.8566 16.7294 10.6197 -45.1927 -36.7422 15.3603 +5443 4 30.4293 17.2093 11.3782 10.0419 -7.15869 -15.9692 +5444 4 30.3248 15.8445 10.5087 28.8517 44.18 3.4025 +5445 6 48.1145 27.7388 10.1259 3.61398 12.7601 13.975 +5446 4 49.0121 27.5791 10.4269 8.16567 7.74751 7.8449 +5447 4 47.9875 27.049 9.49259 -14.0608 -13.1923 -17.2023 +5448 6 27.3333 38.6223 25.6028 2.23096 -19.4823 3.9502 +5449 4 28.2552 38.3493 25.5855 1.31221 -11.4567 4.08925 +5450 4 27.4115 39.4856 25.2253 -6.51803 21.9055 -3.11379 +5451 6 33.3641 5.73966 21.4502 -17.8674 16.1521 -18.7045 +5452 4 32.7333 6.1391 20.8022 11.3762 -13.0233 18.1576 +5453 4 34.2053 6.04196 21.1266 17.0109 2.35293 -3.511 +5454 6 25.3113 5.14231 4.52483 0.627568 -0.448638 -4.7772 +5455 4 25.9311 5.01166 5.26368 -5.83567 -1.85096 0.781095 +5456 4 24.4169 4.85751 4.79359 12.9854 0.158453 3.02285 +5457 6 40.4761 35.641 19.148 -1.79116 -1.08437 4.96155 +5458 4 40.617 35.2798 20.0294 1.97887 -12.6912 2.42284 +5459 4 40.4316 36.5735 19.3404 -1.08207 12.5153 -8.94186 +5460 6 49.6577 30.6259 19.0198 10.1565 -2.14928 -32.2041 +5461 4 49.9169 29.8714 18.4657 1.24638 0.0316256 -4.24874 +5462 4 49.4705 30.2089 19.8368 -7.31172 -12.6811 36.7039 +5463 6 42.1447 28.3235 17.0346 32.2065 -21.7575 -5.76428 +5464 4 41.8825 28.1658 16.1189 -9.06503 7.62036 -2.3435 +5465 4 42.9622 27.7534 17.0825 -24.1402 18.2728 2.552 +5466 6 47.7039 24.5139 36.3396 16.4403 6.39896 -6.79461 +5467 4 46.9537 23.9582 36.5487 -4.01092 -10.0931 -4.11437 +5468 4 48.0889 24.2445 35.4833 -10.0455 -7.86437 4.89019 +5469 6 19.3463 26.9837 19.8062 -14.9609 -0.640093 12.1457 +5470 4 19.5138 26.0435 19.7544 7.81166 -12.6546 -12.1749 +5471 4 18.7209 27.0489 20.5386 2.91516 7.38851 -4.99075 +5472 6 47.0534 26.8134 37.524 14.5946 -27.4581 20.3182 +5473 4 46.5999 27.4025 36.9765 -27.9132 42.868 -22.1392 +5474 4 47.3287 26.1433 36.896 5.92816 -9.16339 3.59921 +5475 6 9.30604 24.6864 40.2824 32.5721 -4.72803 4.84631 +5476 4 9.7425 23.8424 39.9878 -14.1318 19.2209 8.44319 +5477 4 10.0514 25.1942 40.7028 -19.8613 -12.5192 -10.8686 +5478 6 14.4861 17.9115 14.2864 12.9549 -2.10551 -8.28408 +5479 4 13.7677 18.2592 13.7435 1.92348 1.2648 2.86628 +5480 4 15.2633 17.8567 13.6783 -18.4643 2.67645 15.1406 +5481 6 37.1346 38.6824 18.7128 7.24689 -5.58535 -9.53541 +5482 4 36.7159 39.5508 18.578 6.84706 -0.690413 -9.37485 +5483 4 37.7177 38.457 17.9456 -10.6272 10.0511 7.65618 +5484 6 11.4119 5.91281 21.4549 8.51563 -6.63227 17.2429 +5485 4 12.0074 5.45436 22.0841 -12.0343 5.82261 -11.8758 +5486 4 10.9825 5.24051 20.9122 -1.087 -4.70833 -2.40093 +5487 6 4.25375 30.708 16.2346 29.3973 -34.9884 0.269827 +5488 4 4.09384 31.4404 15.6668 -11.3131 25.7038 -10.6546 +5489 4 3.7498 30.7826 17.0293 -13.4231 7.50595 13.7704 +5490 6 17.6719 16.0027 27.067 -23.8279 -26.0778 -36.6424 +5491 4 17.4271 15.046 26.968 10.0078 22.1048 9.82572 +5492 4 17.2008 16.3672 26.2667 15.5193 1.39518 21.9495 +5493 6 36.5109 8.65039 40.4308 12.8187 7.82554 4.51092 +5494 4 36.6212 9.57953 40.6523 1.70353 1.63484 0.0365135 +5495 4 35.6422 8.38915 40.7323 -7.59123 -4.26386 -1.28756 +5496 6 13.6114 12.9582 3.02589 -9.62347 -2.84414 10.0553 +5497 4 13.2363 12.4097 3.76862 19.3807 16.1747 -17.4749 +5498 4 14.4444 13.4268 3.2396 -7.87441 -9.64772 8.81761 +5499 6 38.5595 20.1494 21.6232 12.4359 -2.6335 16.4863 +5500 4 39.2259 20.3435 20.9591 -1.48691 0.443177 -6.45697 +5501 4 37.7118 20.0829 21.2013 -17.1516 -4.14152 -12.2545 +5502 6 50.9933 10.2578 30.842 -13.0607 -20.693 1.71035 +5503 4 51.4592 11.0512 30.6346 13.219 20.5706 -0.472754 +5504 4 50.4501 10.1493 30.0523 -4.00654 -4.85851 -2.78428 +5505 6 16.2749 2.41767 41.3132 30.43 46.2693 -10.4997 +5506 4 15.891 1.63581 41.6436 -18.412 -43.9133 0.0464609 +5507 4 16.2795 2.47169 40.3396 -9.09423 -14.5759 6.47164 +5508 6 16.5834 4.98938 41.8776 -7.21709 18.0228 -35.1788 +5509 4 16.7462 5.00964 0.881122 10.2158 10.5242 44.5139 +5510 4 16.3516 4.0781 41.7536 -3.71457 -12.9135 -9.58407 +5511 6 38.2173 37.6461 20.9885 34.7311 9.53448 3.02785 +5512 4 38.1039 38.1836 20.1861 -3.89758 -6.06348 6.62032 +5513 4 39.1638 37.7895 21.271 -30.6928 -4.57838 -6.40603 +5514 6 27.3006 1.89931 15.7822 -29.9599 0.296682 7.03709 +5515 4 27.5073 1.31215 15.0574 1.93116 -3.76907 -9.96281 +5516 4 26.3073 1.90747 15.8082 23.9237 -0.0762349 1.33551 +5517 6 29.0265 12.4386 37.8107 0.525722 -10.271 3.33822 +5518 4 29.5022 13.2884 37.7591 0.646351 -6.15481 8.15455 +5519 4 29.2991 11.9227 38.6151 -0.523918 21.8031 -11.8471 +5520 6 46.0742 20.1649 18.9021 10.3528 7.89056 -10.7305 +5521 4 45.1842 20.5502 18.8696 3.90233 0.901411 -3.14496 +5522 4 46.6469 20.7119 18.3183 -8.66547 -7.99067 8.59505 +5523 6 2.04022 38.6829 18.5084 -2.98341 9.82285 -40.3455 +5524 4 2.90324 38.7749 18.9245 -0.612017 -3.29975 20.9344 +5525 4 1.3228 38.3823 19.0758 6.43327 -3.78011 20.6074 +5526 6 44.0503 24.9822 25.9794 4.67294 -4.59524 3.88497 +5527 4 44.3373 24.0607 26.0767 4.76241 4.2408 6.41339 +5528 4 43.5759 24.9717 25.1449 -4.92835 3.44315 -2.97359 +5529 6 5.98031 26.6293 4.53551 9.30387 5.64625 14.1271 +5530 4 6.57491 27.1353 5.14729 -11.3776 -17.0368 -12.135 +5531 4 6.21313 25.677 4.5841 -4.82905 19.4284 -2.02229 +5532 6 0.0924267 23.2133 10.9333 1.42961 0.53672 3.80218 +5533 4 0.717354 23.7388 10.4004 2.9288 -9.65077 10.1872 +5534 4 0.580921 22.6863 11.5989 -3.01683 9.30052 -9.37626 +5535 6 39.1222 20.6154 12.8741 28.3348 2.95161 0.461931 +5536 4 40.0468 20.8249 13.1753 -23.4009 -9.33487 -2.82098 +5537 4 38.9932 21.1408 12.0685 -0.0080483 -0.226832 2.68059 +5538 6 39.959 39.9495 18.871 8.01281 1.93571 -21.8826 +5539 4 39.6441 40.4313 18.0693 6.09748 -11.7745 18.4856 +5540 4 39.3412 40.1359 19.5607 -16.2687 5.42221 11.8382 +5541 6 49.288 23.0046 30.5128 21.2206 -9.75551 18.5897 +5542 4 49.5389 23.7528 30.0013 -1.98497 24.1116 -29.9204 +5543 4 49.9896 23.0569 31.1809 -5.40626 -11.587 6.30696 +5544 6 10.3545 2.34292 9.14765 -20.562 40.259 12.8074 +5545 4 10.1012 1.5797 8.68555 -3.02669 -36.876 -18.9145 +5546 4 9.58966 2.94108 8.9894 20.4134 -0.423974 9.05106 +5547 6 9.6115 40.9317 19.7379 12.0905 -27.6191 -4.08509 +5548 4 9.69139 40.7751 18.7589 3.32448 -0.840478 24.839 +5549 4 9.96472 40.0953 20.2033 -15.7711 32.9781 -27.126 +5550 6 29.2535 5.10379 17.4957 6.62295 15.7752 6.05206 +5551 4 28.9547 4.7998 16.6324 -1.76299 0.290572 -5.22762 +5552 4 29.5626 6.02275 17.3534 -3.29284 -14.1281 1.20249 +5553 6 27.0956 15.411 3.22262 8.43004 -47.4217 3.28637 +5554 4 27.2677 16.3043 3.38591 1.16524 52.1129 6.18754 +5555 4 27.741 14.9724 3.82188 -13.792 3.46242 -10.72 +5556 6 32.8341 39.3821 25.1177 -1.66938 -44.1854 21.376 +5557 4 32.6253 40.2767 24.9331 -7.27917 31.8978 1.68524 +5558 4 32.4689 39.1753 26.0219 6.68592 11.3878 -26.9617 +5559 6 34.9613 7.8883 31.2358 4.6626 36.0744 6.61898 +5560 4 34.1778 8.39814 31.5057 7.62156 3.23778 -2.6687 +5561 4 34.6431 7.01199 31.2355 -6.57887 -35.8668 -2.78431 +5562 6 6.13276 36.7597 26.1434 10.8988 16.6869 20.3463 +5563 4 6.63888 37.4372 26.6797 -12.2659 -21.448 -21.9021 +5564 4 6.61066 36.5785 25.3331 5.0666 0.722926 -2.43587 +5565 6 6.00975 25.8323 24.1014 -4.47961 0.932019 -2.36624 +5566 4 6.35352 25.3647 24.9068 -18.3984 14.8695 -13.0656 +5567 4 5.16189 26.3111 24.2876 18.65 -15.8322 7.58859 +5568 6 45.6302 24.3945 2.56021 19.8484 -5.54431 -0.0961329 +5569 4 46.4674 24.0527 2.19931 -2.34639 0.0383291 -2.49188 +5570 4 45.6784 24.1611 3.48508 -4.52597 -1.56916 11.2469 +5571 6 15.5147 11.7041 32.683 14.9804 20.126 19.7749 +5572 4 15.7333 12.537 33.1619 -4.31998 -20.325 -9.45866 +5573 4 14.9494 12.0119 31.9786 -9.0483 1.88099 -11.1618 +5574 6 46.4109 17.7015 37.4781 -27.0258 -32.7931 -28.9932 +5575 4 46.5427 17.8951 38.3867 3.19976 6.65122 29.0636 +5576 4 45.8763 16.8534 37.4192 15.4316 28.8096 -0.764517 +5577 6 39.7197 20.9143 18.534 -24.0731 20.2285 32.8184 +5578 4 40.3775 20.5463 17.9571 20.7324 -0.0260386 -6.5243 +5579 4 40.0771 21.5962 19.1648 -0.0511872 -19.8333 -22.8182 +5580 6 23.8035 28.041 36.6748 9.0016 14.1447 -6.24075 +5581 4 23.3139 27.2938 37.064 2.44252 16.2828 7.25552 +5582 4 23.789 28.845 37.2599 -7.88527 -27.7019 -2.97202 +5583 6 23.2344 0.634844 30.8976 -0.384503 -14.0448 -5.97485 +5584 4 23.3889 41.8653 31.5825 6.30765 2.44689 -9.38002 +5585 4 23.8441 0.49945 30.133 -8.72578 -2.57312 14.648 +5586 6 37.1436 6.89172 28.2858 -3.37167 6.44507 30.6351 +5587 4 36.8056 6.23733 28.9583 11.2574 17.9183 -21.3683 +5588 4 37.4325 7.68669 28.8192 -8.94015 -21.4647 -17.7418 +5589 6 3.23535 6.60909 12.3935 -1.87368 1.73448 8.36027 +5590 4 3.03832 6.9284 11.4867 8.20532 -9.84476 7.71099 +5591 4 3.52123 5.67427 12.3822 -6.77188 11.8795 -6.70084 +5592 6 12.6173 19.1518 31.1213 -5.69854 -18.2223 8.29425 +5593 4 12.5903 18.2248 31.5183 -0.203161 27.8336 -18.7857 +5594 4 12.2771 19.1425 30.2049 2.23067 -5.60852 14.6148 +5595 6 15.1884 38.3149 41.5578 -3.57026 -0.303434 0.776802 +5596 4 15.4085 38.7623 40.7331 -1.55695 3.41656 0.7558 +5597 4 16.0064 37.8692 41.7958 4.70682 -3.66196 2.37744 +5598 6 49.6308 33.3399 19.6427 -23.754 -26.2674 -4.71234 +5599 4 48.6425 33.4171 19.8493 35.7001 -9.4047 -10.4581 +5600 4 49.8006 32.395 19.3286 -9.63678 35.3831 11.1391 +5601 6 6.36026 2.78098 29.8944 3.74937 13.951 -9.77631 +5602 4 6.39713 3.75696 29.8119 -0.635871 -14.0149 2.80012 +5603 4 6.09114 2.63212 30.8044 -1.55083 -4.44243 9.60337 +5604 6 13.1715 31.7798 30.2783 -11.6407 3.9064 -21.9894 +5605 4 12.793 31.9725 29.3819 8.72012 -0.590438 18.6573 +5606 4 12.9685 30.8401 30.4245 2.82441 5.28785 4.26217 +5607 6 32.3245 32.246 24.8932 -0.334642 -17.4514 3.51608 +5608 4 32.5833 31.3985 24.4266 1.55373 29.7789 3.70352 +5609 4 32.7413 33.0821 24.5914 4.2936 -14.9539 -9.40787 +5610 6 41.9919 14.5701 37.4124 -31.8928 -38.2057 -11.1184 +5611 4 41.1925 13.9916 37.278 11.7187 28.3557 2.93562 +5612 4 42.6351 13.8531 37.4242 20.2579 6.94588 1.70752 +5613 6 11.8923 7.24234 27.6655 -13.1666 -25.4093 6.94854 +5614 4 11.7936 6.42612 28.2118 8.91213 18.8361 -2.40188 +5615 4 11.255 7.06027 26.9538 4.64331 9.73453 -0.841263 +5616 6 14.1973 37.538 6.88791 4.07782 -38.2298 -28.3639 +5617 4 14.4575 38.4426 6.80778 6.05638 30.4198 1.96843 +5618 4 14.5936 37.1092 6.07523 -12.6749 10.0326 27.426 +5619 6 14.2479 30.6948 36.0545 7.37408 36.4971 9.0133 +5620 4 14.3981 30.7629 35.1101 2.39159 -10.6067 -11.9788 +5621 4 14.1779 29.7876 36.2972 -1.09854 -35.7585 -0.14866 +5622 6 16.4334 33.6494 5.49228 -9.96541 -28.1856 -5.39099 +5623 4 16.7983 34.5397 5.45321 9.37649 -3.55324 -12.1003 +5624 4 16.7788 32.9912 4.81355 -0.655183 31.9156 12.6517 +5625 6 23.0317 17.1547 7.8473 13.6053 -0.132883 9.10362 +5626 4 22.1841 17.362 7.40272 9.91908 10.567 10.3381 +5627 4 23.4804 17.9296 8.30446 -24.7767 -19.3244 -18.4116 +5628 6 51.7425 20.8913 27.7088 32.6403 -5.30395 6.54704 +5629 4 51.4526 20.615 28.6066 9.31531 5.01366 -13.1678 +5630 4 52.7523 20.9899 27.7096 -40.0215 -4.95426 2.55021 +5631 6 2.19474 27.6072 28.8013 -23.9703 3.8216 12.4498 +5632 4 2.89306 28.2617 29.0045 8.22653 -14.998 -10.5048 +5633 4 2.42593 26.8662 28.2089 10.4722 10.3682 5.46115 +5634 6 17.2069 14.3387 7.70681 0.210359 -30.5014 22.2216 +5635 4 16.8342 14.1932 8.62484 13.2745 1.87397 -27.442 +5636 4 17.791 13.5503 7.49447 -17.8498 26.4292 5.4189 +5637 6 12.462 8.93964 14.7065 0.798528 8.71873 -6.67623 +5638 4 12.2438 7.98523 14.5568 11.6803 11.8078 17.0064 +5639 4 13.0577 9.12873 15.4809 -12.5262 -17.6243 -12.8578 +5640 6 42.4139 38.0579 9.76413 -20.5008 17.2265 16.0611 +5641 4 43.2035 37.8944 10.2554 20.3834 -6.45835 6.72371 +5642 4 41.8905 38.6035 10.3913 3.31942 -7.4886 -15.3201 +5643 6 51.8227 30.3513 28.272 -27.6927 -20.9124 31.2363 +5644 4 51.4089 31.1514 27.9711 0.163888 16.7369 -10.597 +5645 4 52.6546 30.2313 27.8441 24.1641 3.9866 -16.3823 +5646 6 0.181148 18.531 4.58976 -5.95747 22.8787 14.3331 +5647 4 0.30783 18.164 3.72574 1.94264 -10.8238 -19.8991 +5648 4 0.385506 17.861 5.23812 2.38695 -15.8688 4.81738 +5649 6 34.1492 0.61754 2.99129 -49.6439 4.42439 -16.0687 +5650 4 33.2398 0.938351 2.63038 43.5613 -10.8791 15.5023 +5651 4 34.8325 1.13587 2.566 3.67212 10.3309 -6.27046 +5652 6 49.171 17.2374 23.1529 12.6877 -22.0026 -17.2704 +5653 4 50.1002 17.5391 23.0823 -12.4494 -3.65532 2.68691 +5654 4 49.1558 16.3609 22.6932 2.16788 22.8154 9.36775 +5655 6 23.1488 6.5083 23.6124 -20.5997 37.6057 -45.0229 +5656 4 23.0491 7.12001 22.8007 18.1878 -21.95 27.0503 +5657 4 22.2316 6.45775 23.8939 -1.28085 -6.53623 13.7239 +5658 6 11.0806 24.0842 29.2705 -8.73998 -10.3514 -18.9502 +5659 4 11.2441 23.4599 28.5168 0.0150655 10.4905 16.9308 +5660 4 11.7296 23.9083 29.9561 7.87164 -2.5542 2.12029 +5661 6 36.5429 4.08242 21.672 0.786556 -8.94696 -15.3954 +5662 4 36.4501 4.49554 22.5359 -3.35109 8.47972 1.84417 +5663 4 36.356 4.76727 20.9996 1.47044 -5.20042 11.1851 +5664 6 31.3053 25.6355 24.591 -3.66138 3.71718 3.54675 +5665 4 31.1335 26.2845 25.3159 5.93159 -20.4343 -13.8963 +5666 4 32.0778 25.0682 24.8002 -7.66178 11.3294 7.22687 +5667 6 42.6065 23.0403 14.7613 -16.8309 4.03618 -45.3098 +5668 4 42.9655 23.4598 13.9577 -8.276 -4.36486 -1.00498 +5669 4 43.204 23.3098 15.4118 29.6291 10.3091 46.448 +5670 6 14.3159 11.6727 8.8813 -14.5655 -17.9373 -12.2817 +5671 4 13.3434 11.4421 8.85146 29.9821 6.96631 -2.22077 +5672 4 14.7728 10.9717 8.34565 -11.3371 15.3318 14.175 +5673 6 21.498 2.14139 3.39648 14.7702 -17.8734 -6.06988 +5674 4 22.405 2.21099 3.73647 -11.0312 3.8274 -0.37696 +5675 4 21.4855 1.24815 2.9799 -4.51333 14.3419 9.54204 +5676 6 22.4606 27.6741 39.0725 -9.38699 -8.57051 -12.0691 +5677 4 22.9487 28.2157 39.6788 9.87489 12.9386 7.45564 +5678 4 22.251 26.9021 39.5804 -3.7481 -10.0177 3.53978 +5679 6 37.2705 33.4961 30.0614 -4.9469 -17.1986 11.1636 +5680 4 36.5019 32.9393 30.3108 14.0133 8.69925 -1.52787 +5681 4 38.0636 33.0902 30.4641 -13.5236 2.40347 -6.71067 +5682 6 41.8394 20.8621 40.0097 -20.8091 -17.9415 -11.9484 +5683 4 40.8821 20.7467 40.2088 17.4772 5.45688 -4.89215 +5684 4 42.2425 21.2111 40.795 8.11745 4.61319 15.3924 +5685 6 10.0509 31.1054 22.2556 20.3961 -18.8014 17.2446 +5686 4 9.98499 30.8639 23.2007 -4.95143 3.66172 -13.3958 +5687 4 9.23459 31.4918 21.9926 -24.2979 8.76968 -3.95477 +5688 6 24.2243 35.3747 6.62617 -9.42531 -3.96828 -6.7527 +5689 4 23.2865 35.2144 6.56466 -9.91939 -6.68958 -24.4488 +5690 4 24.2401 35.6133 7.54088 22.4532 10.3619 17.5563 +5691 6 54.2249 13.3694 18.759 -24.737 -0.349871 -1.41807 +5692 4 53.5933 13.3703 18.006 15.3609 1.78219 9.05355 +5693 4 53.6566 13.499 19.5435 10.7967 -0.400371 -8.89572 +5694 6 12.4855 25.1013 17.4456 -6.57337 13.5018 5.68311 +5695 4 11.9686 25.7405 17.9864 9.67417 -13.0798 -6.23069 +5696 4 12.9177 24.4729 18.0482 -8.67745 6.31928 -4.55572 +5697 6 22.3956 33.969 18.8874 -5.8063 -1.6479 -7.81353 +5698 4 22.8035 34.4497 18.1359 -8.0332 -6.19684 5.18696 +5699 4 21.6693 33.408 18.5182 22.6878 13.045 2.20471 +5700 6 24.4435 12.9292 5.84415 8.74588 -19.8564 16.0901 +5701 4 24.6262 13.8512 5.99703 -0.326218 20.1414 -4.57271 +5702 4 23.8078 12.8376 5.13214 -2.90401 5.95194 -4.82348 +5703 6 13.3959 11.2335 28.6038 -6.74888 -5.61354 -5.54718 +5704 4 13.7674 10.4842 28.0847 -9.93712 8.82772 12.9583 +5705 4 12.6218 10.8864 29.0903 8.08376 -4.51111 -11.0518 +5706 6 20.9645 34.7015 21.139 -6.51648 1.45471 -0.425004 +5707 4 21.4543 35.0255 21.9119 2.52902 -3.67403 -7.94594 +5708 4 21.5071 34.7067 20.3201 -1.1119 -0.149268 16.7291 +5709 6 37.136 34.5081 26.161 6.62209 -8.97684 -22.2932 +5710 4 37.2438 34.333 25.2112 -5.73965 -6.14541 10.65 +5711 4 37.5173 35.375 26.2088 1.33918 12.2816 12.8311 +5712 6 49.3593 27.1123 23.4681 27.9614 -13.0657 2.71617 +5713 4 48.46 27.3383 23.3348 -38.0547 10.3981 -3.53627 +5714 4 49.5827 26.632 22.6632 1.14175 -6.15755 -6.01297 +5715 6 2.6463 41.7198 27.6524 7.3894 17.9878 -25.5957 +5716 4 2.49639 41.7504 26.6775 -8.79282 -10.4379 14.5056 +5717 4 3.38399 0.440368 27.7439 -10.0848 -7.80081 10.7778 +5718 6 28.2486 5.66281 0.851705 -28.2484 -11.3463 5.20358 +5719 4 29.1342 5.88017 0.643235 30.8656 11.4658 -5.99415 +5720 4 28.269 4.69693 0.891643 -4.88577 1.64465 1.4719 +5721 6 46.3319 19.9354 30.6504 10.2867 19.401 8.99033 +5722 4 46.9123 19.9353 29.8821 -3.84989 -4.07474 -6.11394 +5723 4 46.5975 20.7732 31.0971 -12.3274 -18.5124 -2.17733 +5724 6 3.63748 25.7835 21.5531 -13.3498 -8.40935 -29.3244 +5725 4 3.82697 24.8656 21.7578 10.5845 0.467441 11.0774 +5726 4 3.24958 25.6945 20.6565 5.98204 10.7305 11.6574 +5727 6 2.75525 19.0991 29.6309 -15.3907 3.66354 13.2976 +5728 4 3.52302 18.6052 29.9384 7.69741 -2.11378 -3.28897 +5729 4 2.98375 19.5594 28.8227 11.6258 3.58084 -5.99316 +5730 6 11.8998 35.7779 24.2574 -1.81403 7.91701 -5.71356 +5731 4 12.4147 34.9912 24.3376 10.7342 -20.9531 7.85436 +5732 4 12.5443 36.3811 23.8879 2.19538 16 -3.69366 +5733 6 52.3427 30.4062 14.294 22.5839 4.39347 1.37497 +5734 4 52.8745 31.0934 14.7488 -8.66891 -1.23278 -4.46489 +5735 4 51.4935 30.7804 14.0876 -13.5204 11.8147 1.32314 +5736 6 0.0822874 24.3672 32.1291 -8.34182 -9.5272 -6.40877 +5737 4 0.828194 24.8082 31.7001 -5.59692 5.0286 6.41936 +5738 4 -0.0482457 24.7479 33.0025 4.35174 8.79498 5.58774 +5739 6 31.4966 23.7292 38.8152 19.1094 38.0757 -4.99319 +5740 4 31.5999 23.5133 39.7508 -8.21927 -12.2318 -1.63758 +5741 4 30.9751 23.0699 38.3783 -13.0662 -23.7861 4.62116 +5742 6 52.1169 21.6052 3.50792 14.3711 -14.904 -13.5765 +5743 4 52.8807 21.6364 2.89306 -16.3122 -4.91238 6.22228 +5744 4 52.1257 22.4771 3.8768 -2.65107 18.1744 9.91254 +5745 6 31.7478 33.9414 11.5999 6.40399 -14.705 -7.35618 +5746 4 31.326 34.316 12.3745 -3.98661 3.76902 9.36008 +5747 4 32.1024 33.0666 11.8569 -5.74966 15.1553 -0.43871 +5748 6 7.04869 17.6722 16.6738 15.5169 9.78585 -46.6303 +5749 4 6.86408 17.1452 17.4554 -1.12856 -17.4359 1.80272 +5750 4 7.18951 17.0724 15.8577 -9.09698 16.5018 49.1326 +5751 6 51.856 41.8666 22.1892 3.84753 25.5265 -21.3427 +5752 4 52.3772 41.4924 22.8897 9.65371 -13.9556 16.5062 +5753 4 51.0512 41.3628 22.1522 -12.8828 -14.9996 6.2925 +5754 6 50.8708 9.92691 25.9357 -19.3562 -16.2947 3.52683 +5755 4 50.5833 10.1225 25.0455 -2.85771 2.39787 -5.58996 +5756 4 51.6551 10.4289 26.0882 17.2727 16.0662 4.10656 +5757 6 8.99927 39.8664 13.8488 -8.14038 -13.6283 -23.156 +5758 4 9.59929 39.3497 14.3885 6.06913 -3.61279 3.55219 +5759 4 8.79522 39.3067 13.0547 7.60199 16.2117 22.1745 +5760 6 40.7023 25.5302 0.148896 6.79038 -13.4508 8.01702 +5761 4 40.3789 25.4701 1.07476 14.4856 1.96217 -11.1718 +5762 4 41.6802 25.6099 0.149801 -17.1473 -2.90233 2.89792 +5763 6 46.6909 7.84537 22.8702 9.17253 9.27189 2.7581 +5764 4 46.223 7.4121 23.6122 6.69651 11.5962 -1.82232 +5765 4 47.0858 8.70418 23.1544 -10.5797 -14.2101 5.83025 +5766 6 21.013 12.9106 9.96683 -11.4772 33.9385 12.3935 +5767 4 21.4714 12.292 10.5062 17.1864 -22.5118 18.142 +5768 4 21.2487 12.7153 9.07972 8.38308 -10.8862 -30.7653 +5769 6 24.8549 0.515446 28.6008 5.68052 19.4063 -7.13145 +5770 4 24.6132 0.0822417 27.7678 -2.25298 -0.561161 -0.933523 +5771 4 24.9931 1.46483 28.3802 -3.69568 -16.6941 4.65055 +5772 6 9.93738 22.6806 8.27387 -17.0851 30.8612 6.83622 +5773 4 10.4469 21.9921 7.84938 5.97494 0.327216 -18.4105 +5774 4 9.65147 23.3826 7.61609 12.4321 -25.0338 8.46255 +5775 6 33.2759 9.25001 23.8237 4.47891 -44.2955 15.8461 +5776 4 33.2652 10.105 23.448 0.909732 36.8069 -18.0196 +5777 4 34.1325 8.84557 23.5962 -5.93924 6.51534 1.57833 +5778 6 47.795 20.3665 34.2866 5.36639 25.6433 -13.2606 +5779 4 47.2589 21.0165 33.753 7.81309 -27.8153 16.882 +5780 4 47.2984 19.5618 34.502 -10.2742 8.68957 -7.27829 +5781 6 7.49437 13.498 41.0843 -1.51987 -1.91843 -16.5508 +5782 4 7.4491 13.1887 40.147 4.71488 4.53153 18.247 +5783 4 8.31974 13.1617 41.4819 -4.68073 -1.19795 -7.02436 +5784 6 9.95832 23.5973 1.60681 5.21402 2.49741 5.68021 +5785 4 10.4402 24.1882 0.998507 -5.12041 -6.82862 1.89989 +5786 4 9.65493 22.8254 1.1174 1.14228 -2.219 -8.51506 +5787 6 27.3184 14.1623 11.3341 -13.0256 18.3326 19.191 +5788 4 27.0532 14.8043 10.6617 -0.288735 -3.87647 -1.15481 +5789 4 27.1082 14.6278 12.1878 10.7132 -11.7932 -20.1286 +5790 6 25.8363 31.783 17.8928 12.257 -31.4953 -8.75538 +5791 4 26.5912 31.2312 17.6268 -16.3657 -3.28218 2.7807 +5792 4 26.257 32.5845 18.0942 8.13437 40.9862 10.9181 +5793 6 28.5106 34.3419 0.227626 33.3873 17.7784 12.057 +5794 4 28.9852 33.8482 0.904042 3.3493 0.859906 2.37016 +5795 4 27.7339 33.8559 0.0766936 -35.6263 -19.3635 -8.63216 +5796 6 39.4752 27.6784 22.7097 42.3367 15.2059 -23.9811 +5797 4 38.5679 27.9307 22.8105 -22.3645 11.7157 0.32019 +5798 4 39.9498 28.4084 22.1978 -16.9125 -22.6846 16.1018 +5799 6 19.4034 35.5119 37.6428 33.5095 -11.1022 16.798 +5800 4 18.7953 34.9333 37.2031 -16.031 -7.23993 -11.3762 +5801 4 20.0399 34.8524 38.0282 -15.2165 20.9239 -9.15559 +5802 6 40.2577 30.223 10.7322 40.2352 -13.6393 -47.8395 +5803 4 40.0003 30.153 11.624 -20.3139 3.96126 40.955 +5804 4 39.7054 30.7997 10.2038 -14.6911 14.5022 3.62333 +5805 6 44.8252 28.467 36.0943 -27.9317 -39.6182 20.2271 +5806 4 44.1 27.9067 36.617 42.0807 42.9759 -26.5645 +5807 4 44.8315 29.4044 36.3472 -5.71594 -8.07431 0.279077 +5808 6 17.9328 13.9421 34.2756 -23.0398 37.6904 -16.8553 +5809 4 17.2847 14.658 34.0723 21.6532 -14.16 -3.36915 +5810 4 17.4769 13.4978 34.9742 -2.33669 -21.4636 20.9706 +5811 6 22.7722 11.8049 25.9053 18.1639 13.4769 -8.32772 +5812 4 22.5143 10.954 26.1764 -32.0329 -27.8082 11.3637 +5813 4 23.7113 11.6387 25.939 19.9678 17.8754 -6.33473 +5814 6 27.9844 31.9785 40.3628 4.4159 -7.73511 16.6787 +5815 4 28.3104 32.752 39.9101 2.36742 5.81951 -9.83175 +5816 4 27.6866 31.3262 39.7216 -3.89657 2.92736 -3.90823 +5817 6 29.7056 5.13899 29.6966 36.1554 -28.1732 -9.81385 +5818 4 29.3242 5.52633 30.4675 -11.5775 13.5815 21.5043 +5819 4 30.5867 4.74321 29.9895 -34.1051 15.4003 -14.984 +5820 6 3.10893 21.4798 2.76501 -7.99866 -19.5262 -7.43282 +5821 4 2.82658 22.3873 2.73831 -4.86294 14.1814 1.21532 +5822 4 2.47005 21.0041 2.20282 6.80672 4.92349 5.4824 +5823 6 13.6497 30.6638 39.7451 -45.1888 -1.5 -27.4221 +5824 4 14.5316 30.8766 39.996 26.4643 7.88404 -4.33129 +5825 4 13.4124 30.9677 38.8135 13.6057 -6.06521 34.9266 +5826 6 39.188 23.0895 28.2562 15.2318 22.185 -40.3341 +5827 4 39.2961 23.1894 27.2636 -4.5014 -1.37473 28.8386 +5828 4 38.6302 22.3345 28.3879 -14.2617 -17.3372 5.24228 +5829 6 16.9988 23.7489 0.769214 20.7079 -15.4466 5.05665 +5830 4 16.2107 23.4786 1.24898 -3.68938 2.33828 -2.20359 +5831 4 17.6949 23.1909 1.19915 -10.9726 17.7258 -9.6056 +5832 6 0.328251 33.6592 13.0294 5.05621 13.0457 -18.8804 +5833 4 55.0348 32.9975 13.677 0.78154 12.2617 9.8199 +5834 4 0.388277 34.5816 13.3997 -6.36603 -34.6234 2.68168 +5835 6 49.1005 40.6595 16.9496 -9.76098 4.73909 -13.8177 +5836 4 49.2151 40.9775 16.0207 -4.23419 -6.48803 14.4163 +5837 4 48.1506 40.7848 17.1408 8.79948 2.71791 -6.65809 +5838 6 52.1337 39.9918 15.1756 26.7545 10.0433 -2.50902 +5839 4 51.9708 40.0067 16.1202 -6.38877 -4.81519 5.40892 +5840 4 51.3465 39.7494 14.7166 -22.4824 -4.17003 -7.64187 +5841 6 29.052 37.1033 37.836 19.097 -0.968932 -4.5801 +5842 4 29.682 36.5364 38.3049 -8.87198 1.40853 -5.4338 +5843 4 28.3717 37.2982 38.474 -12.8547 4.6316 9.68073 +5844 6 4.87585 1.47991 27.5772 1.0193 4.57332 -1.4391 +5845 4 5.21258 1.06654 26.7686 1.92757 2.57678 7.5628 +5846 4 5.62617 1.67061 28.1638 -3.61661 -2.55781 -2.1886 +5847 6 43.5959 24.3463 30.211 -19.7182 -5.92862 14.3815 +5848 4 44.3514 23.9347 29.8066 13.2495 -10.0411 -7.84874 +5849 4 42.954 23.6392 30.3929 6.93549 5.0637 -4.64144 +5850 6 33.7524 3.52358 22.9355 4.65558 -3.45748 -24.1115 +5851 4 34.2253 2.7722 22.5212 -9.10678 14.6802 11.3369 +5852 4 33.6063 4.18077 22.2154 2.29559 -11.8514 17.7295 +5853 6 19.8909 13.4517 25.3922 5.25873 -5.74859 -7.9771 +5854 4 20.5096 14.0736 25.7535 5.66529 16.002 2.33546 +5855 4 19.9521 12.7313 26.0185 -3.34295 -15.2779 0.0169051 +5856 6 47.3737 23.1767 39.6212 -5.95621 11.0118 4.46955 +5857 4 47.7191 22.5265 39.0041 4.75348 -8.18234 -7.77672 +5858 4 47.7813 24.0201 39.3891 1.84918 -0.94156 0.213564 +5859 6 20.1771 18.6734 32.3906 -2.68035 -24.6067 18.319 +5860 4 19.7167 19.3347 31.8914 0.274713 15.8779 -14.5216 +5861 4 21.1289 18.7867 32.3383 1.39014 4.37005 -4.23212 +5862 6 0.462706 5.80795 25.6713 -7.84599 -7.21428 -45.242 +5863 4 0.323825 6.56383 25.0471 7.25451 -11.4554 20.6165 +5864 4 0.632949 6.14438 26.5418 1.37183 20.4375 17.7538 +5865 6 6.87393 19.55 31.9207 -32.7339 30.668 -22.5905 +5866 4 6.24577 19.9891 32.5577 15.6688 -11.8235 -17.9631 +5867 4 6.64633 19.9665 31.0139 13.7505 -20.7976 33.8805 +5868 6 6.72837 20.2799 38.5105 -3.64262 3.78431 -13.5507 +5869 4 5.92588 20.8248 38.5086 9.85336 -2.70512 -1.72466 +5870 4 6.83039 19.9897 39.4188 -3.49896 1.12624 1.5432 +5871 6 22.0356 25.927 12.2605 -11.8373 -4.76705 -8.63625 +5872 4 21.2326 25.5939 11.7351 40.6868 7.42656 16.975 +5873 4 22.8707 25.497 11.9923 -13.8486 -7.11072 -10.1952 +5874 6 39.3057 7.93299 2.64755 -0.118713 9.42534 0.0803503 +5875 4 39.6638 8.10481 3.53463 2.86319 -1.68774 -0.268253 +5876 4 39.5974 7.06378 2.35963 5.09861 -8.7519 2.38745 +5877 6 29.9647 22.0457 34.4057 2.14844 7.25734 -28.1517 +5878 4 30.9338 21.915 34.3365 -18.2911 3.03872 -0.832433 +5879 4 29.6238 22.2503 33.4865 4.56359 -4.84177 28.516 +5880 6 37.5951 16.2788 0.369586 8.64826 -19.3515 -0.400608 +5881 4 37.1939 15.3927 0.526929 9.97291 14.3398 -5.3998 +5882 4 38.4404 16.082 41.8172 -10.5319 -0.823814 4.55326 +5883 6 11.7218 13.8845 21.8896 14.7882 -39.2126 -46.5495 +5884 4 11.9305 13.3995 21.0267 -7.58848 27.5443 23.8472 +5885 4 11.7147 13.1405 22.4934 -2.11531 -1.20748 18.2217 +5886 6 33.352 10.9238 27.6262 4.19409 14.5082 -21.7958 +5887 4 32.741 11.5866 27.2704 3.79692 -6.80494 8.02232 +5888 4 34.0591 10.8732 26.9373 -11.2958 -2.76298 18.1193 +5889 6 30.9422 36.5217 10.1011 0.546516 -38.0529 -7.53065 +5890 4 31.037 36.4313 9.10316 -3.7795 -1.86296 33.6151 +5891 4 30.9555 35.5897 10.5034 1.2522 32.9448 -19.5962 +5892 6 45.5828 6.56917 25.2425 13.4794 -38.3135 -0.0969536 +5893 4 44.6735 6.51564 25.4913 -20.1668 12.9455 3.79285 +5894 4 45.8221 5.605 25.2656 2.31227 28.4662 -4.04899 +5895 6 9.53612 30.0233 12.041 13.8898 -20.9008 -19.4413 +5896 4 9.92894 30.5763 11.3437 -1.97905 0.820167 2.98642 +5897 4 9.13364 30.6129 12.6538 -15.721 17.9312 16.9413 +5898 6 53.0747 24.9738 1.38132 -1.86355 2.7084 19.7503 +5899 4 52.7154 24.2509 0.898374 -13.0694 -24.4059 -9.99565 +5900 4 53.2522 25.5795 0.686793 9.94881 23.634 -11.856 +5901 6 26.1984 24.7352 0.509304 -7.53082 -0.727442 -26.3589 +5902 4 25.609 24.783 41.6367 17.1237 -12.5609 6.929 +5903 4 25.7967 25.3842 1.06587 -1.32139 13.3231 25.2347 +5904 6 23.0109 2.41889 11.5345 -1.81733 -0.917938 -19.7561 +5905 4 22.156 2.16845 11.9124 1.98231 0.963836 1.10425 +5906 4 22.831 2.471 10.5696 1.38956 0.195961 11.1121 +5907 6 29.9165 12.8947 31.0013 41.0722 8.15666 -12.068 +5908 4 30.8272 12.8901 31.3843 -23.6061 -3.22469 3.62361 +5909 4 30.1671 13.0589 30.0659 -21.5099 -4.3955 11.2257 +5910 6 24.0423 16.1922 40.3682 -11.7161 -52.7791 -12.7633 +5911 4 23.7963 16.7427 41.0863 -4.03022 37.1909 22.8519 +5912 4 24.4513 16.6836 39.6566 3.29428 17.0417 2.56802 +5913 6 21.8759 29.9137 12.7377 16.7673 9.38207 5.68416 +5914 4 21.0615 29.603 12.3447 -12.732 2.54077 -5.12984 +5915 4 21.8572 30.8889 12.7388 -3.49843 -10.2696 0.0943897 +5916 6 45.2049 12.2865 6.6319 2.92472 30.2037 5.62675 +5917 4 45.4908 11.5347 6.14771 0.0808414 -27.1796 -10.0093 +5918 4 45.9331 12.9133 6.49804 -8.49251 3.31449 4.74769 +5919 6 7.58748 25.3948 38.035 37.4402 -5.69153 16.1754 +5920 4 8.20159 25.1941 37.2709 -20.479 6.14302 24.9331 +5921 4 8.13335 25.2556 38.8857 -20.6102 5.92378 -35.7711 +5922 6 46.1732 7.83303 16.6988 4.4841 14.5494 -17.535 +5923 4 46.5452 7.84101 15.8027 -9.24205 10.2202 -0.760543 +5924 4 46.6945 7.14485 17.0776 9.771 -19.5689 22.069 +5925 6 54.9675 12.85 7.71106 -14.5426 11.3809 9.40253 +5926 4 54.9732 13.8139 7.75484 8.59467 -0.566973 -8.90089 +5927 4 54.3786 12.658 8.45528 8.25441 -10.7611 -5.52346 +5928 6 26.93 39.6729 37.1759 35.4319 -17.0193 24.0328 +5929 4 27.7049 39.4447 36.6239 -16.3058 8.04164 -6.8945 +5930 4 27.2164 39.2553 38.0316 -23.1866 12.5553 -17.3208 +5931 6 27.0277 8.92497 38.0115 25.8258 -15.1538 -19.4143 +5932 4 26.3205 9.53863 38.1727 -14.2244 17.8778 -0.0983549 +5933 4 27.5327 9.26244 37.2322 -14.307 -2.33761 14.5508 +5934 6 8.04621 7.65921 29.9125 5.96085 -8.8046 12.0925 +5935 4 8.66182 7.92407 30.6202 -6.26406 -0.422529 -8.96361 +5936 4 7.80891 8.46925 29.4702 -0.676119 14.2 -7.80782 +5937 6 27.8751 27.8625 12.1001 -31.3933 22.4686 19.454 +5938 4 27.5095 28.719 12.4446 7.36494 -19.3603 -4.77408 +5939 4 28.6439 28.079 11.5991 25.5597 3.40516 -15.3306 +5940 6 23.5464 30.4867 38.1533 -1.61625 -6.62341 9.61758 +5941 4 24.0833 30.8354 38.8715 -5.37174 -4.61911 9.80189 +5942 4 23.9933 30.8636 37.4157 3.53805 3.96797 -22.0348 +5943 6 48.0805 24.2983 17.323 -13.282 16.609 -1.2587 +5944 4 47.4189 24.8263 17.8481 20.4082 -10.1323 -14.146 +5945 4 48.1392 24.7467 16.448 -1.93384 -6.90404 13.1726 +5946 6 38.5137 5.30503 40.3397 -7.95418 19.3032 15.6478 +5947 4 38.8605 4.51762 39.8919 14.9068 5.60332 0.485922 +5948 4 39.0782 6.12858 40.3573 -2.94219 -25.5867 -8.28862 +5949 6 31.2334 3.92786 33.7298 9.31662 9.08835 -13.8199 +5950 4 31.8178 4.24357 33.0198 -6.00608 1.6224 5.38661 +5951 4 31.5957 3.05883 33.9262 -1.57661 -10.2527 7.73336 +5952 6 41.2417 8.81323 38.1247 -0.484904 -12.0607 11.4744 +5953 4 40.9476 8.42023 38.9721 -0.376638 9.54125 -7.13918 +5954 4 41.2604 9.77162 38.2616 1.58028 -2.03482 4.89657 +5955 6 53.3602 29.1001 24.587 -11.0956 7.72569 2.80506 +5956 4 52.5731 28.5594 24.8544 13.5868 20.3826 -7.54714 +5957 4 53.0545 29.9696 24.221 1.09296 -21.6534 7.27768 +5958 6 54.9204 15.5334 40.7094 -9.73888 -15.8123 9.62316 +5959 4 54.8689 16.4143 40.4003 18.499 35.235 -15.9181 +5960 4 53.9936 15.418 40.9228 -4.36807 -19.1537 6.40504 +5961 6 46.4046 17.0769 31.8825 -4.88415 8.61979 -0.317809 +5962 4 46.5643 17.9902 31.5503 -4.54791 -14.0743 0.407713 +5963 4 45.6863 16.6828 31.3336 12.87 12.2001 8.08584 +5964 6 36.9136 25.0502 23.0508 4.56287 5.14957 -21.3849 +5965 4 37.1181 25.0639 23.9643 8.53293 7.7605 31.6671 +5966 4 36.2092 24.4176 22.9617 -10.0712 -5.98832 -5.36051 +5967 6 11.3786 4.43396 15.9309 9.37238 17.2608 -3.05203 +5968 4 11.3458 3.5794 15.4688 2.43716 9.1998 0.97888 +5969 4 11.7026 5.12247 15.2999 -5.70859 -16.4138 5.77914 +5970 6 12.7896 7.06818 19.4525 -2.66824 36.6483 10.7184 +5971 4 12.9865 6.29411 18.9417 0.495259 -24.323 -4.17525 +5972 4 12.2519 6.828 20.2299 7.04203 -8.59773 -13.3487 +5973 6 12.0617 33.6499 17.5439 8.15138 -13.8576 -23.5514 +5974 4 11.882 34.0654 18.3682 -11.1792 16.7137 24.4072 +5975 4 12.5902 32.8825 17.8108 -1.08307 -0.300652 -3.52071 +5976 6 10.2421 4.75805 2.56564 19.3085 -11.8452 1.86691 +5977 4 9.45693 4.42703 2.99801 -10.4664 -1.42643 2.59081 +5978 4 10.9264 4.04527 2.68225 -6.18235 16.1727 -3.70264 +5979 6 4.57251 36.8735 12.1563 3.74049 -23.6741 -21.1206 +5980 4 4.47996 37.7154 12.5491 -11.9533 34.2042 20.255 +5981 4 5.43811 36.9355 11.7449 0.921031 -10.3689 -0.351167 +5982 6 30.7412 35.3317 25.8213 -33.1423 -23.543 6.44877 +5983 4 31.2776 35.279 26.6136 10.5944 3.70967 -1.00248 +5984 4 29.9668 34.7615 26.0677 13.1622 11.7399 -12.7178 +5985 6 20.1808 7.16217 1.863 30.1084 16.4868 -11.867 +5986 4 20.9002 6.54767 2.16414 -16.0511 17.5979 -8.58506 +5987 4 20.6676 7.94845 1.45686 -14.4541 -29.1822 13.3394 +5988 6 21.7608 6.89709 28.9964 -11.5861 -1.80466 -8.03013 +5989 4 22.036 7.16072 29.8728 6.26891 1.69864 13.9065 +5990 4 22.5393 6.5849 28.5353 8.83449 0.101288 -1.59126 +5991 6 6.87368 37.1369 6.9386 0.0966708 26.3677 27.0276 +5992 4 7.29364 38.0249 6.81033 -7.58004 -19.2864 -7.26696 +5993 4 6.61926 37.1727 7.88431 1.83825 -7.02501 -19.6681 +5994 6 37.1919 18.383 16.2937 29.0289 34.5069 -53.2335 +5995 4 36.6258 18.6038 17.011 -19.1901 14.6481 22.2869 +5996 4 37.3395 19.2625 15.7718 -11.4936 -34.1346 27.3139 +5997 6 52.3871 25.4845 31.3088 43.0013 26.9533 24.6388 +5998 4 52.3889 26.4071 31.692 -12.9868 -26.5619 -15.078 +5999 4 53.3562 25.2868 31.368 -25.5563 -9.18093 -7.26498 +6000 6 3.9438 39.8542 16.3866 5.1752 -27.5036 1.27902 +6001 4 3.12325 39.6837 16.8533 -2.95342 6.97088 0.658243 +6002 4 4.2268 38.9387 16.1321 1.7457 31.291 -0.663648 +6003 6 26.0576 14.6358 18.3044 5.96149 26.4073 -5.45028 +6004 4 27.0205 14.6227 18.4365 -6.17521 2.0803 0.6884 +6005 4 25.8163 15.5963 18.2277 1.60591 -22.5499 1.70317 +6006 6 22.193 39.6312 23.63 -9.05536 -28.9999 9.83005 +6007 4 22.6639 40.3889 23.3083 10.2118 22.7493 1.36107 +6008 4 21.7625 39.8434 24.4837 8.53947 8.47814 -10.8223 +6009 6 5.99591 12.8758 22.3742 5.3436 -0.661706 -0.190442 +6010 4 6.14325 13.1833 21.4713 -0.679137 1.38292 -0.893953 +6011 4 6.87425 12.6139 22.6767 3.78948 -2.07704 1.05968 +6012 6 48.9338 28.1628 34.7078 -35.8712 26.2385 4.15493 +6013 4 48.201 27.5556 34.4701 19.6025 -0.265843 1.21851 +6014 4 49.8217 27.8183 34.7001 12.2446 -20.4038 -3.75147 +6015 6 7.76997 22.4407 33.2353 -5.03116 -11.9457 7.57841 +6016 4 8.01899 22.0009 34.0594 5.33952 7.11928 -2.86974 +6017 4 7.10669 21.8538 32.8613 -1.17853 4.26119 -2.40878 +6018 6 41.0955 39.6222 11.7091 10.6381 -27.5326 3.52715 +6019 4 40.5189 40.2602 11.288 0.0449404 21.7474 -0.525631 +6020 4 41.8612 39.9918 12.1934 -14.1016 15.1893 -9.59654 +6021 6 26.8828 37.915 39.359 -2.28209 0.567193 11.8658 +6022 4 27.0774 38.1179 40.3058 -8.7685 -4.90824 -13.677 +6023 4 25.9807 37.5277 39.3071 12.6176 5.79057 5.20946 +6024 6 16.8333 41.5427 16.7885 -17.5694 -7.84814 -1.75502 +6025 4 17.5277 0.148354 16.3589 5.69783 -2.62712 11.3029 +6026 4 16.9979 41.3393 17.726 8.37907 5.88226 -10.2657 +6027 6 19.018 8.99657 17.6669 -0.857073 -13.2853 32.8939 +6028 4 18.786 9.90902 17.9004 1.19423 -0.949069 -3.8378 +6029 4 19.1413 8.47286 18.5173 -2.13518 15.132 -32.6231 +6030 6 31.1034 24.3848 20.0884 -4.53251 11.7336 -2.81937 +6031 4 30.5766 24.6463 20.8643 6.13742 -4.20791 -6.36966 +6032 4 31.7352 25.0989 19.9557 0.422515 0.146513 0.562515 +6033 6 24.595 6.30881 27.6069 -9.90555 -11.0232 -14.6341 +6034 4 24.6965 6.6392 26.7007 0.89989 8.76246 8.56835 +6035 4 24.5083 5.35606 27.4824 0.344086 -1.65377 9.53776 +6036 6 11.6335 5.32908 8.21523 29.3959 14.5761 -12.3078 +6037 4 10.744 5.12885 8.4339 -32.4949 -9.42488 11.9016 +6038 4 11.5648 6.10082 7.62627 0.276207 -9.77668 5.48929 +6039 6 16.478 34.2375 17.2464 48.0037 -1.61779 7.84119 +6040 4 15.7306 34.6529 16.8034 2.48832 11.605 -8.49411 +6041 4 17.405 34.6677 17.061 -56.7063 -17.2336 2.19282 +6042 6 40.7477 40.4696 8.51561 8.11488 -8.65224 -15.2287 +6043 4 40.0224 40.6832 9.09702 -8.50867 2.70994 6.70857 +6044 4 40.4514 39.6579 8.0617 2.3787 8.8385 5.97324 +6045 6 42.7444 5.87231 14.2984 24.2128 7.61876 -1.56509 +6046 4 42.0757 5.96647 14.9632 -14.4615 -1.80987 8.42029 +6047 4 42.482 5.17586 13.6922 -11.2697 -3.69634 -0.0191913 +6048 6 14.3614 21.0573 6.06698 -40.3301 2.02826 20.3099 +6049 4 14.5082 21.6099 6.85229 1.25225 -5.13952 -5.68983 +6050 4 15.1941 20.9025 5.67555 35.2665 -1.55979 -15.977 +6051 6 16.3015 37.7733 18.121 -25.7671 9.10936 -15.4408 +6052 4 15.381 38.1761 18.2458 41.2545 -15.1679 7.93486 +6053 4 16.7788 37.6858 18.9587 -11.1023 5.71932 1.62274 +6054 6 40.7984 27.7161 27.1129 -11.0179 0.499807 -0.336913 +6055 4 41.4742 27.2927 27.66 5.56711 1.79851 -1.75817 +6056 4 41.2133 28.334 26.4954 6.67104 -1.0644 4.19578 +6057 6 44.9561 25.991 14.0487 25.7727 -16.7938 -19.0088 +6058 4 45.3739 25.1637 13.7108 -16.5098 12.8855 15.8726 +6059 4 45.5476 26.6442 13.6478 -7.0093 2.51014 3.36733 +6060 6 2.61494 33.9473 21.2474 -9.6198 2.06317 -4.83635 +6061 4 2.13704 34.7904 21.3802 4.44423 -7.12162 -0.559399 +6062 4 2.10703 33.4352 20.5879 2.52794 8.8644 7.26413 +6063 6 5.77575 4.45209 12.8318 1.03208 18.7287 8.08797 +6064 4 5.35339 3.69685 13.2518 -3.06112 -10.1665 -2.69945 +6065 4 5.8052 5.15326 13.507 0.887863 -7.02627 -5.52828 +6066 6 16.8649 5.92112 7.40874 19.9951 -5.29142 4.66315 +6067 4 16.4994 5.07825 7.12483 -4.58221 -9.71617 -5.56506 +6068 4 16.109 6.48147 7.52662 -16.4719 8.95214 3.19539 +6069 6 17.8298 38.4233 36.8534 9.258 40.3096 -0.310058 +6070 4 17.7926 39.4131 36.8935 -6.04129 -19.7424 1.84578 +6071 4 18.5177 38.2893 36.201 1.93535 -10.8086 -1.92368 +6072 6 43.3019 20.5959 5.44166 -6.9278 5.85438 -3.52603 +6073 4 43.1055 21.501 5.07158 -2.97833 -26.833 8.04502 +6074 4 42.4661 20.0651 5.41852 11.3272 16.2867 -2.99003 +6075 6 21.5372 23.2991 30.4448 -14.935 11.2275 -26.3705 +6076 4 20.9947 23.0537 31.1809 -7.12546 -6.28648 20.8256 +6077 4 20.8648 23.582 29.7655 22.6032 -4.28693 10.3415 +6078 6 0.251317 28.0486 36.1651 -22.0243 21.0356 -19.5016 +6079 4 1.02049 27.7114 36.6113 18.9729 -1.47718 6.47801 +6080 4 0.506474 28.8456 35.6445 2.58205 -12.8812 9.00708 +6081 6 3.04678 17.0589 11.5707 1.23946 -7.00965 -18.5436 +6082 4 3.14519 17.2619 12.4977 -1.89892 8.1653 13.6088 +6083 4 2.54959 17.7766 11.1613 1.73961 1.36316 5.23635 +6084 6 24.1645 37.0333 23.9496 -13.0802 10.7124 17.6799 +6085 4 23.6099 37.8384 23.8849 6.1763 -9.33563 -1.28122 +6086 4 24.4663 37.0147 24.8893 -3.58635 -1.49958 -18.3056 +6087 6 3.94341 20.5209 27.4789 6.12038 36.4957 26.1587 +6088 4 3.64002 20.0757 26.7101 -13.0247 -10.3927 -30.3524 +6089 4 3.8213 21.4921 27.3096 0.6263 -21.942 -1.90407 +6090 6 54.8381 2.78983 29.6272 25.3782 12.002 29.7256 +6091 4 54.8259 2.49183 30.5832 -3.08894 8.50949 -25.0172 +6092 4 0.681738 3.33643 29.5869 -23.0163 -14.7319 0.890579 +6093 6 27.1738 8.43221 31.7209 4.37325 44.8318 10.1666 +6094 4 26.7765 8.21235 30.8513 3.34031 12.9925 0.247925 +6095 4 27.4394 9.43578 31.8184 -18.7706 -51.1708 -12.8964 +6096 6 30.9422 1.62815 30.3909 7.68258 9.19266 14.5116 +6097 4 30.6848 0.902997 29.8247 -17.6873 -14.6962 -9.63211 +6098 4 30.1385 1.96768 30.8202 -2.70664 -9.08975 -4.26502 +6099 6 26.4126 36.4396 36.8407 14.7094 2.78685 2.16538 +6100 4 26.1754 35.936 36.0621 -1.37556 -1.6634 -9.1832 +6101 4 27.3614 36.6667 36.7609 -11.9856 -2.56278 0.470716 +6102 6 51.3051 10.055 21.7064 16.9271 -12.7171 -0.47742 +6103 4 50.71 9.38094 22.0984 13.3581 11.7028 -6.50503 +6104 4 52.1297 9.58932 21.3894 -28.6693 12.5934 9.83408 +6105 6 52.4269 12.3712 23.2743 -6.4707 23.0639 13.1163 +6106 4 51.7645 13.1043 23.2119 13.6159 -11.3613 1.42096 +6107 4 52.024 11.6223 22.842 -6.69009 -13.0182 -9.76131 +6108 6 10.0084 38.37 20.6075 21.9453 -2.41338 -4.30271 +6109 4 9.45069 38.2813 21.3825 -6.19229 -0.201962 6.85596 +6110 4 10.9137 38.1225 20.8794 -8.5598 0.614521 -3.9406 +6111 6 22.7031 33.2664 0.640708 10.9794 6.62646 4.85135 +6112 4 23.6679 33.2996 0.582378 1.56947 7.5672 2.73741 +6113 4 22.5144 32.4288 0.230474 -14.5468 -15.5809 -6.04383 +6114 6 14.0917 40.8812 25.4864 9.18744 8.89463 -14.7226 +6115 4 14.196 40.6884 26.4283 -5.63746 -5.20078 0.271339 +6116 4 13.2439 40.5125 25.1796 5.27736 1.6069 9.18822 +6117 6 42.7681 15.0783 14.9763 7.15748 5.71054 -2.59845 +6118 4 43.0785 15.7158 14.2901 -5.10451 -16.9901 16.8665 +6119 4 41.8327 15.2592 15.1092 -5.54173 -0.124331 1.80857 +6120 6 30.2406 7.22111 8.53832 -0.545825 26.9265 -4.64375 +6121 4 30.1758 8.19473 8.52708 -1.1145 -9.52086 -16.9196 +6122 4 30.4024 7.07989 9.45321 5.06633 -17.0605 24.2519 +6123 6 3.37759 19.8423 41.3077 23.4194 0.89426 -0.123069 +6124 4 3.19865 19.3681 40.4829 0.842743 3.23829 1.04749 +6125 4 4.34953 20.0012 41.2688 -20.407 -4.57585 2.1738 +6126 6 8.87423 25.1354 17.2017 -10.0567 -4.23249 -18.7298 +6127 4 8.96932 24.947 16.2256 5.94886 2.92938 28.6011 +6128 4 9.65182 24.8278 17.6915 0.0257745 -5.63434 -9.64419 +6129 6 9.32494 14.9555 22.0283 -12.5325 4.5599 7.62514 +6130 4 9.01993 14.8718 22.9489 -0.27625 1.365 -7.1979 +6131 4 10.1958 14.5523 22.0148 2.38734 -2.44115 -2.54227 +6132 6 2.03086 4.7751 20.8592 -0.302533 -25.5342 -8.8148 +6133 4 2.76807 5.37577 20.9697 7.90436 11.3601 5.00545 +6134 4 1.2576 5.15949 21.2703 -7.54078 11.376 6.7073 +6135 6 18.2964 7.06718 3.86051 -0.633466 1.54328 39.8902 +6136 4 18.916 7.22135 3.16498 20.2468 5.35447 -22.1173 +6137 4 18.8081 6.54637 4.52758 -12.8964 10.087 -8.61721 +6138 6 17.0178 19.1734 19.8425 8.05121 8.342 4.19715 +6139 4 17.786 18.9037 19.3194 -9.06534 -4.96345 -2.22737 +6140 4 16.269 18.585 19.6427 11.1227 0.819232 -3.01639 +6141 6 4.30363 6.55267 21.3463 7.67654 -0.43578 -3.38259 +6142 4 4.33009 7.06923 20.5107 4.36212 -5.74714 10.2686 +6143 4 5.22777 6.26626 21.5669 -20.6993 9.2157 -12.5452 +6144 6 20.7848 36.9284 35.662 4.03453 1.95325 3.7669 +6145 4 20.2254 37.0836 34.8976 -2.25577 1.87165 -3.27163 +6146 4 20.2383 36.4327 36.2875 0.848364 -0.11832 4.44878 +6147 6 4.7306 15.0205 31.2333 -1.91968 -20.8619 8.65585 +6148 4 4.4229 14.7734 32.1398 6.18773 10.2906 -17.1472 +6149 4 4.73385 15.973 31.1263 -2.35963 8.87481 4.31723 +6150 6 2.35358 1.22877 17.5767 10.9459 -8.92502 -6.22121 +6151 4 3.05741 1.28614 16.8672 -19.772 5.07478 19.7417 +6152 4 1.94409 2.09607 17.7592 7.86728 -5.07336 -5.26938 +6153 6 34.6221 31.5613 19.8029 0.0167231 -1.91103 -0.857839 +6154 4 35.0026 31.8698 18.9629 1.12657 -3.13716 4.28436 +6155 4 34.4223 32.3623 20.3103 -0.485441 0.265221 -3.01806 +6156 6 24.1912 21.6103 13.5173 31.6251 8.72647 13.7111 +6157 4 25.0921 21.8731 13.8418 -25.6554 -7.43575 -12.369 +6158 4 23.5893 22.1875 13.984 -2.65104 7.77201 2.87587 +6159 6 37.2187 41.0834 5.69361 1.76676 -13.0415 -0.936073 +6160 4 37.8761 41.7354 5.91144 16.7665 3.57334 0.125879 +6161 4 36.4089 41.5349 5.88363 -19.4064 5.82624 -1.33385 +6162 6 8.4323 8.00063 20.2395 28.2224 -17.334 -6.20124 +6163 4 9.29892 8.115 20.6547 2.73811 -3.60152 -0.447724 +6164 4 7.94828 8.69862 20.6224 -29.3938 29.4062 12.6481 +6165 6 14.9357 18.8843 36.7618 11.8158 33.7978 0.271425 +6166 4 14.1259 19.2123 36.362 -3.40669 -6.42507 -0.135577 +6167 4 15.5651 19.6361 36.6422 -7.52364 -17.7077 5.06346 +6168 6 43.9725 40.6444 18.6569 4.16672 -2.33153 16.0012 +6169 4 43.9166 40.834 17.7203 0.682613 4.51617 -13.4207 +6170 4 44.9212 40.6761 18.9032 -12.0211 -3.47257 -3.21486 +6171 6 33.7852 32.2494 37.3449 -11.8504 2.76306 -14.1758 +6172 4 34.0177 32.2775 36.4055 -1.41242 -0.232407 11.1732 +6173 4 34.3686 31.6236 37.7745 10.7747 -2.06792 3.13276 +6174 6 5.09749 29.2901 24.0356 16.7213 -6.5526 19.7529 +6175 4 5.77222 29.487 24.7328 -11.5239 -2.29901 -14.2657 +6176 4 4.7684 30.1321 23.7215 -1.73734 11.0072 -2.10513 +6177 6 33.6153 36.4198 10.9805 1.47517 3.52666 5.33615 +6178 4 32.7579 36.4403 10.5596 -3.06779 3.10292 -7.60642 +6179 4 33.384 36.4828 11.91 5.71512 -0.747971 7.16991 +6180 6 28.3006 33.5952 13.1115 6.62888 -15.4249 13.7129 +6181 4 27.948 33.7778 12.2398 -4.56551 -8.24283 -4.77521 +6182 4 28.1705 32.6462 13.2914 -0.364449 12.3294 -7.26248 +6183 6 6.16378 19.058 24.2919 3.99573 -9.29146 -27.7059 +6184 4 6.01812 19.825 24.8144 -3.49512 27.1397 16.8881 +6185 4 6.29927 18.3335 24.8859 3.7649 -20.2974 16.0908 +6186 6 28.4267 19.9356 1.8581 6.30761 1.98196 1.30153 +6187 4 28.5945 19.3745 1.10227 -2.74725 -9.675 -9.29711 +6188 4 29.2893 20.1184 2.23075 1.76934 5.71608 2.57016 +6189 6 42.0557 23.969 9.55925 -0.174378 -1.97525 4.49576 +6190 4 42.3037 23.8044 10.4694 5.92504 9.79373 11.5418 +6191 4 41.7282 23.1152 9.29053 -8.19873 -12.6145 -11.7634 +6192 6 43.5187 7.30226 27.4319 7.08124 -12.3985 0.368771 +6193 4 42.7424 7.14751 27.9838 -5.23639 1.01312 3.8871 +6194 4 43.2552 7.97753 26.8025 -4.71413 8.37143 -8.21745 +6195 6 20.4824 33.0041 9.27291 -32.573 -27.3267 34.6611 +6196 4 19.7824 32.5876 9.93875 35.2414 32.5831 -36.6535 +6197 4 20.3431 33.9616 9.1663 -10.2228 -2.75758 9.24016 +6198 6 38.0326 35.2526 15.9362 -7.94884 -19.6622 -5.99631 +6199 4 37.3459 34.9971 15.2894 4.63074 2.95951 5.93375 +6200 4 37.9463 34.6017 16.6504 2.45283 5.99568 -2.76115 +6201 6 47.5301 20.8853 3.96175 -5.34824 -5.66637 20.3565 +6202 4 47.9759 21.3648 3.2498 -4.9297 7.97101 8.48596 +6203 4 47.5029 21.3928 4.81786 6.75175 -1.3172 -26.6206 +6204 6 10.9933 31.6966 41.4271 11.47 5.02521 -0.853614 +6205 4 11.6392 31.7665 40.7132 0.112137 -5.28149 3.10577 +6206 4 10.1353 31.6993 40.998 -8.62143 -0.203152 -1.66696 +6207 6 43.2403 12.6562 2.57215 9.62694 -8.68348 -18.5989 +6208 4 42.9077 12.993 3.39384 -2.38679 2.43178 19.528 +6209 4 44.033 12.1261 2.78242 -8.9232 8.2725 3.71991 +6210 6 49.4204 25.4105 21.1683 5.59269 -12.2048 -2.72561 +6211 4 50.0196 25.2987 20.4097 -7.64964 4.29225 2.01473 +6212 4 48.8877 24.5919 21.195 1.69169 7.44836 1.02425 +6213 6 1.95674 34.1403 26.4747 8.8762 -24.2704 6.47661 +6214 4 2.77674 33.6103 26.5537 -12.4269 14.6955 -4.62849 +6215 4 1.26657 33.4613 26.3994 -1.21739 9.31774 -1.03397 +6216 6 17.1306 20.8229 36.6851 -31.9931 14.1441 13.8122 +6217 4 16.9533 21.7471 36.9985 5.62896 -19.6931 -5.93312 +6218 4 18.0634 20.696 36.5868 23.783 -2.64609 -3.70934 +6219 6 36.6048 10.9866 3.71548 -5.44552 8.31799 24.2539 +6220 4 35.7423 11.3886 3.87785 -5.6936 5.55042 -13.8219 +6221 4 36.8135 10.7077 4.61447 10.9535 -7.59336 -0.361553 +6222 6 14.2169 20.6838 21.9439 11.6961 23.12 -6.3106 +6223 4 13.8085 20.2376 21.1912 1.98746 8.13024 -7.83415 +6224 4 14.8103 21.4259 21.6461 -14.674 -27.097 -1.82439 +6225 6 33.9151 12.2544 9.54899 39.8857 -26.0408 -21.0892 +6226 4 34.3088 11.5163 10.0208 11.0461 -3.70138 -11.6499 +6227 4 33.2997 12.4814 10.1903 -47.9458 31.9244 32.2008 +6228 6 21.8056 41.4836 2.15686 0.64336 -1.87746 -8.80618 +6229 4 22.0354 41.6672 1.22189 -5.57638 1.91412 12.8342 +6230 4 22.5122 40.9391 2.50884 5.16687 -0.375256 0.644554 +6231 6 20.9282 10.4547 14.1996 25.019 -0.0729632 25.5582 +6232 4 21.5922 10.842 14.8375 -21.0894 -6.80718 -21.5316 +6233 4 20.826 9.54084 14.5456 -0.887825 12.9084 -9.51249 +6234 6 6.24616 4.45231 24.6293 -10.9468 0.993291 2.39826 +6235 4 6.83688 4.17894 23.9311 12.242 -0.137787 -14.9911 +6236 4 5.68087 3.68408 24.7586 -3.59028 -1.51582 -1.5433 +6237 6 50.784 14.5954 23.4824 21.8736 9.84292 5.60122 +6238 4 51.2681 15.1205 24.1582 -9.03857 -7.6656 -10.4761 +6239 4 49.9341 14.3608 23.8519 -7.60536 -4.54693 6.65168 +6240 6 52.7678 13.9144 9.68214 -3.90955 36.1598 -0.40974 +6241 4 52.8738 13.0144 9.92216 4.47335 -34.5538 7.53363 +6242 4 51.8729 14.0092 9.35938 -14.036 0.105332 -6.17221 +6243 6 9.05048 2.05234 29.9152 -29.3842 -12.1538 -14.6176 +6244 4 9.42756 2.83336 30.2687 13.3628 24.1087 13.7335 +6245 4 8.09173 2.26823 29.8032 18.9866 -6.39081 0.174186 +6246 6 7.13499 29.9757 26.2377 7.52656 -33.046 2.78556 +6247 4 6.52748 30.39 26.8607 -0.20976 -1.88395 4.87081 +6248 4 7.49713 29.1538 26.6869 -11.4544 24.9502 -11.4644 +6249 6 49.1541 41.742 14.3355 11.4439 21.5488 -10.6063 +6250 4 49.5333 41.2573 13.5835 -2.72613 -5.13007 3.47372 +6251 4 49.526 0.750494 14.2401 -8.50163 -23.9907 2.80869 +6252 6 5.64545 3.82333 19.1929 -5.43924 -10.1162 19.2647 +6253 4 5.12472 3.39384 19.906 6.51959 7.46947 -11.8792 +6254 4 5.07872 3.8651 18.4273 -3.31865 2.78603 -7.74707 +6255 6 9.32747 35.8381 24.9081 -3.67476 7.0144 6.61099 +6256 4 10.2167 35.7622 24.5243 -1.5306 1.39279 3.84516 +6257 4 9.42305 36.4736 25.6393 1.10498 -0.920313 -3.33942 +6258 6 53.0258 29.7567 11.5493 -1.29773 -2.97991 8.71205 +6259 4 53.4398 30.4104 10.9769 2.6525 4.63524 -3.89524 +6260 4 52.8324 30.2122 12.386 1.27544 -1.91261 -4.55584 +6261 6 22.6082 9.97702 5.69106 1.45951 -2.04334 43.7981 +6262 4 23.4598 10.2484 6.09617 -7.85329 -3.83944 -13.5574 +6263 4 22.5497 10.2693 4.79236 2.60512 5.60546 -21.7219 +6264 6 39.5532 19.6216 2.68726 -3.50035 -14.5445 -22.3968 +6265 4 38.6563 19.3067 2.54039 -1.65167 0.121811 17.9309 +6266 4 39.9003 19.405 1.80953 18.3116 7.78412 6.67062 +6267 6 45.082 35.5833 7.81025 20.3465 -2.3491 -25.2688 +6268 4 45.1219 36.3229 8.40611 -5.73741 11.9797 15.8104 +6269 4 44.452 34.9332 8.12016 -12.4923 -3.86067 9.83054 +6270 6 29.7976 14.244 9.96067 -5.32248 -4.64296 1.12628 +6271 4 30.0443 14.0971 9.02808 -4.18819 -1.64606 2.67632 +6272 4 28.8444 14.0269 10.0606 18.5465 4.64021 -4.02524 +6273 6 29.2523 30.155 21.8932 -5.77992 6.30922 3.94049 +6274 4 29.1431 30.8143 21.21 -7.42967 10.4849 -3.0507 +6275 4 30.0153 29.6632 21.6201 11.6336 -14.2167 -2.13367 +6276 6 11.1107 18.8213 6.56056 -14.6836 -1.88929 0.635516 +6277 4 11.166 19.7501 6.27543 7.98891 -2.6539 -0.194038 +6278 4 11.9915 18.4225 6.59495 6.41359 9.14832 -2.51569 +6279 6 13.4142 39.1371 13.4638 17.7807 -10.3765 -23.6259 +6280 4 13.7831 39.7975 14.0449 5.16656 9.87024 9.85065 +6281 4 12.6066 38.8468 13.8734 -16.0883 -5.26763 6.93978 +6282 6 50.1521 12.9948 0.13749 23.7903 11.3983 42.7862 +6283 4 49.8531 12.6437 41.2486 -17.3674 -16.2897 -43.7514 +6284 4 50.6811 12.2823 0.528204 -2.61001 5.26075 1.59628 +6285 6 47.8279 31.3538 27.7873 0.535952 -14.579 -21.2406 +6286 4 47.8981 31.8966 28.5732 -11.876 9.28639 5.42067 +6287 4 46.9879 31.5201 27.3031 12.1261 3.81279 14.9113 +6288 6 27.708 1.63283 7.49454 14.1634 -3.44528 -21.3886 +6289 4 26.9442 1.71926 8.04828 -16.4795 3.87106 10.0363 +6290 4 27.4331 1.03137 6.77318 -2.44435 3.14912 6.58235 +6291 6 54.8843 20.7912 16.041 -0.591057 -23.5277 -19.4313 +6292 4 54.9506 20.9946 16.9763 2.49267 -3.51754 11.2958 +6293 4 0.215527 19.8591 15.8725 -6.64294 24.8159 10.1677 +6294 6 37.4309 32.9919 34.4461 -3.01999 17.5498 0.613574 +6295 4 37.2599 32.074 34.6492 -8.98721 -14.1314 1.69718 +6296 4 36.602 33.3843 34.0789 10.8556 -9.90957 7.57788 +6297 6 19.516 39.775 6.74949 1.2991 -23.719 -0.568837 +6298 4 19.1628 39.2461 5.9771 11.6696 10.1577 21.4746 +6299 4 19.8715 39.1258 7.41882 -10.6166 14.587 -19.1486 +6300 6 32.439 2.74298 8.0597 2.15016 14.1028 28.0311 +6301 4 32.8474 3.04427 8.91221 -2.20578 -4.83758 -21.9226 +6302 4 31.6043 2.37221 8.38063 -2.27075 -4.50389 -9.9889 +6303 6 12.9757 16.0783 4.05517 0.782156 -17.4841 -11.0101 +6304 4 12.5393 15.6612 4.81952 2.97976 0.136191 -5.67644 +6305 4 13.3707 15.3387 3.55371 -3.64889 7.0956 8.52646 +6306 6 4.65115 29.9533 5.41887 4.80886 14.2508 -32.4371 +6307 4 5.0407 30.2031 4.52094 -17.5959 -12.1853 28.663 +6308 4 3.95879 29.263 5.26663 23.43 17.9812 0.878069 +6309 6 29.754 32.1152 24.0535 7.2798 7.01713 3.37681 +6310 4 30.6602 32.1649 24.4187 -11.1956 -0.828668 -6.39664 +6311 4 29.7572 31.4388 23.3746 -2.03067 -7.97912 -3.55015 +6312 6 11.8649 30.6972 33.4692 4.66278 -43.8766 26.3819 +6313 4 11.8723 29.8544 34.0435 -6.78391 38.5593 -23.2698 +6314 4 12.7601 30.7129 33.1118 -0.162199 2.5806 0.32685 +6315 6 17.3589 40.4121 27.3072 22.6925 26.1242 -9.80885 +6316 4 17.3318 41.3765 27.4299 10.8839 -2.3351 -5.50809 +6317 4 16.5554 40.1462 27.6883 -41.5002 -17.3681 16.6281 +6318 6 8.67113 4.89706 8.92484 12.0335 -9.87957 -4.1983 +6319 4 8.33733 5.39218 8.1724 -5.0195 2.6367 -1.72337 +6320 4 8.22391 5.22927 9.70847 -2.49168 4.71619 2.25155 +6321 6 39.5722 17.6819 9.57834 18.7012 -23.4437 -36.958 +6322 4 39.2207 17.6668 10.4653 -7.32211 -9.11094 11.7967 +6323 4 39.6226 16.7555 9.16114 -8.90732 35.1542 21.3272 +6324 6 31.4906 30.1663 28.5669 -18.2413 -3.40307 10.1233 +6325 4 32.2933 30.4252 28.099 2.93126 -8.695 5.25695 +6326 4 31.6493 29.3506 29.0723 8.50077 6.58979 -7.17605 +6327 6 52.667 19.2904 40.0609 -3.10376 4.72625 -3.48654 +6328 4 52.9542 18.5867 39.4362 -2.88314 13.2503 8.01058 +6329 4 53.0181 20.1618 39.7754 -0.243354 -8.89628 -7.05583 +6330 6 3.24103 7.80987 9.85575 15.4795 13.9798 -0.387217 +6331 4 3.75934 8.59525 10.1836 -13.0283 -21.6848 -11.3123 +6332 4 3.84189 7.30622 9.27659 -5.58147 6.91981 6.81825 +6333 6 23.1336 35.2172 35.587 -21.8844 -14.3383 30.559 +6334 4 23.8289 35.3646 34.9695 18.2116 12.6911 -23.5817 +6335 4 22.438 35.8962 35.5045 5.76256 0.966742 -5.52301 +6336 6 19.4997 14.0668 20.8253 -20.4482 -5.33672 -12.8711 +6337 4 19.9465 14.5101 21.5526 -0.10572 6.16799 9.82761 +6338 4 18.517 14.0876 20.9737 19.1914 1.01522 3.6393 +6339 6 23.6166 15.8675 24.0247 18.6101 -11.8924 -11.0295 +6340 4 23.7056 16.8159 24.0204 -5.88143 19.7526 4.0278 +6341 4 24.4592 15.5679 23.6279 -14.5441 0.474754 5.50536 +6342 6 0.271665 30.4941 6.10208 19.3679 10.4089 38.3983 +6343 4 55.0639 30.1609 5.24948 -13.9023 -9.5098 -30.2095 +6344 4 54.47 30.83 6.54681 -8.02886 -2.57547 -7.81581 +6345 6 4.88814 13.205 29.1223 -11.8587 -43.2127 -22.2411 +6346 4 4.78002 13.8458 29.7909 -3.08187 32.2273 31.1649 +6347 4 5.63816 13.4614 28.593 12.4558 6.3486 -8.85318 +6348 6 54.2078 27.2696 19.1963 -15.9712 -23.151 25.2067 +6349 4 0.0774591 27.3551 19.591 11.6552 0.895327 2.86932 +6350 4 54.2345 27.7605 18.3958 2.66703 17.7524 -27.3595 +6351 6 13.918 35.7451 9.18145 -1.78919 -38.7722 -17.1362 +6352 4 13.6805 34.9997 8.54227 8.11159 28.2534 18.027 +6353 4 13.9675 36.5302 8.63631 -0.993585 8.08981 -9.4946 +6354 6 5.91273 31.9181 18.8024 -12.4461 1.37758 17.74 +6355 4 5.51416 32.8097 18.9023 4.86685 -6.68339 -12.1033 +6356 4 6.30341 31.7597 17.9414 -1.0189 10.0948 -10.5031 +6357 6 5.79665 28.8753 9.48388 1.22923 1.68801 -9.18455 +6358 4 5.13151 29.3325 10.0083 -4.81051 1.68465 1.48607 +6359 4 5.29369 28.2634 8.9143 2.26517 5.17431 2.85494 +6360 6 40.1173 6.05944 9.72118 13.8961 -11.6659 -14.1698 +6361 4 40.0092 6.65032 8.94634 5.33155 -13.6 11.5113 +6362 4 40.8322 5.39707 9.49335 -23.1878 23.6737 0.508505 +6363 6 20.33 13.449 41.3936 11.1096 -0.534149 -19.18 +6364 4 21.2311 13.7006 41.7531 -26.0398 -5.61362 -19.048 +6365 4 20.2547 13.6822 40.4168 8.50391 -3.95591 26.8537 +6366 6 14.4455 21.736 27.3642 10.1345 -2.11962 18.0607 +6367 4 15.3888 21.7922 27.5976 -10.3958 0.0660495 -7.924 +6368 4 14.3649 21.6255 26.4124 4.42937 0.724974 -0.20238 +6369 6 38.7561 1.79551 30.0553 7.9914 -17.3849 -15.575 +6370 4 38.4573 2.01955 30.9195 -8.42419 6.13431 27.6354 +6371 4 38.9299 2.64677 29.6557 3.10695 8.29419 -8.65227 +6372 6 5.60526 10.8558 14.1801 -12.7318 -17.5226 5.68918 +6373 4 4.9397 11.5438 14.0518 -0.153792 0.369728 -2.18729 +6374 4 5.10481 10.0791 14.5379 11.5553 16.0131 -9.09073 +6375 6 45.3957 36.7129 27.9145 12.4213 23.5208 -28.0365 +6376 4 46.0624 36.7782 28.6036 -4.12954 -6.22049 8.27184 +6377 4 45.8092 37.2197 27.1638 -19.7894 -19.9635 17.4029 +6378 6 54.0798 35.0308 20.3994 -2.843 -1.86615 -11.5734 +6379 4 53.8804 34.0877 20.4832 1.52986 -2.36109 -0.337181 +6380 4 53.937 35.2424 19.4598 0.882668 -0.831705 10.9264 +6381 6 42.0694 14.2202 28.4717 21.1483 -3.98018 21.7174 +6382 4 41.9885 13.9669 29.4143 -10.3093 2.59547 -11.4583 +6383 4 43.02 14.3987 28.405 -3.82604 1.35242 -7.96462 +6384 6 34.8498 7.69636 26.7062 10.2576 -3.81921 3.94078 +6385 4 35.6291 7.30563 27.124 0.895866 5.46509 7.50645 +6386 4 34.5698 7.0105 26.0965 -7.64543 -1.95318 -6.87837 +6387 6 49.6738 30.7035 23.8555 -19.3272 -4.41511 -13.3992 +6388 4 50.4901 31.166 23.8286 28.3544 13.2291 -0.764283 +6389 4 49.8241 29.9642 24.4268 4.30872 -17.0733 16.2757 +6390 6 50.9008 7.796 14.1645 9.55664 -5.64416 8.78132 +6391 4 50.8079 7.01141 13.6383 2.57079 -23.1487 -4.84087 +6392 4 50.5017 8.45024 13.6177 -13.1237 27.0593 -11.2067 +6393 6 4.26801 39.4668 27.8349 5.05862 -9.29033 0.915363 +6394 4 3.69733 40.2352 27.9464 -2.13812 3.43039 0.251988 +6395 4 3.85787 38.9439 27.1453 -8.48589 -4.99062 -8.23097 +6396 6 8.74801 32.8245 8.20645 -16.3778 -23.5545 -4.64115 +6397 4 8.1587 32.1369 7.77132 15.1044 25.0089 5.08958 +6398 4 8.83862 33.6223 7.65804 -4.44885 -3.27239 -3.39484 +6399 6 52.9644 25.4956 9.38778 -23.0628 41.5097 8.07386 +6400 4 51.9653 25.4466 9.50894 36.2156 4.27363 -7.84863 +6401 4 53.1697 26.4737 9.50477 -8.20239 -39.1491 -3.41364 +6402 6 29.5595 36.7246 19.4744 18.9803 -2.04176 16.4704 +6403 4 29.6949 37.303 18.726 -4.20274 3.37351 -9.90607 +6404 4 30.4598 36.6303 19.854 -15.3589 -5.02994 0.251134 +6405 6 52.32 36.0811 25.1124 8.57954 -21.5781 -32.5589 +6406 4 53.081 35.9362 25.6725 3.50304 3.9365 6.54391 +6407 4 51.6308 36.4579 25.6293 -16.5409 10.2166 18.3955 +6408 6 21.1806 15.7021 31.1799 -1.73968 4.64344 -14.8668 +6409 4 20.7524 16.2958 30.5301 6.89899 -9.15256 14.6363 +6410 4 20.4997 15.2544 31.7027 -1.32541 3.0922 -5.22806 +6411 6 10.6615 22.4234 39.4446 2.77058 -10.3375 -21.7461 +6412 4 10.8237 22.5242 38.4595 -6.54577 -4.89624 27.0726 +6413 4 10.2823 21.5329 39.6036 8.10661 10.4602 -7.72978 +6414 6 25.1119 11.6683 22.7275 17.9584 10.1803 -43.002 +6415 4 25.2932 11.5881 23.6503 -10.3644 -4.73542 30.1579 +6416 4 24.2275 11.4525 22.4127 -3.04384 -6.16919 15.0614 +6417 6 31.7847 10.4664 2.90738 14.6232 4.92747 -25.5509 +6418 4 32.6367 10.8084 3.16838 3.35352 3.27745 17.8769 +6419 4 31.9203 10.4929 1.94425 -15.217 -5.45404 8.94289 +6420 6 52.4827 36.4345 22.1596 -7.80713 -36.8893 3.58418 +6421 4 53.0619 36.0081 21.4904 -7.85296 7.00584 7.09748 +6422 4 52.1113 35.6558 22.6625 11.8438 27.843 -13.8236 +6423 6 46.2218 40.0356 27.0002 3.00948 19.3103 18.0239 +6424 4 46.4695 39.2891 26.4839 7.60887 -23.2108 -12.3358 +6425 4 45.8298 40.6551 26.3816 -4.98516 2.75312 2.41297 +6426 6 24.0859 36.731 39.1057 28.0861 3.14637 -13.7231 +6427 4 23.7868 35.8298 38.9338 -5.18553 -0.74556 5.28182 +6428 4 23.4629 37.185 39.6652 -17.6872 -1.49015 10.8999 +6429 6 22.3474 7.42423 31.8108 -22.1464 -34.764 6.81692 +6430 4 22.3426 8.34479 32.0749 -0.491553 12.3501 5.32307 +6431 4 21.6443 6.94951 32.3421 24.5486 22.6275 -17.4273 +6432 6 14.3601 18.3609 4.10227 -5.91068 -17.6869 34.0105 +6433 4 14.0198 17.4467 4.00899 4.58845 16.3972 -3.13031 +6434 4 14.1964 18.4938 5.07185 10.0688 2.42213 -23.7444 +6435 6 27.3176 38.4584 0.118061 26.6324 1.72941 22.4386 +6436 4 26.8721 39.2229 0.514978 -6.24738 0.955789 -1.68833 +6437 4 28.1825 38.4197 0.615747 -27.5588 -2.17115 -12.0629 +6438 6 18.6641 0.153005 12.2455 -30.1585 11.9093 7.70812 +6439 4 17.6838 0.288413 12.4195 29.795 -10.6896 -3.23208 +6440 4 18.9224 41.3021 12.7767 -6.14336 -8.14908 8.56265 +6441 6 49.4289 24.9791 25.34 -2.93287 6.40986 -7.21031 +6442 4 48.5336 24.6845 25.5066 -4.79022 -10.2209 3.00881 +6443 4 49.2657 25.7332 24.7569 10.0796 0.538989 -0.302405 +6444 6 52.0657 20.2866 15.752 -30.988 -5.77477 12.2451 +6445 4 52.9883 20.4648 15.7877 30.7647 6.19501 2.10932 +6446 4 51.7487 20.318 16.6754 2.59628 0.707672 -8.61894 +6447 6 49.6694 15.6466 38.5033 -2.36871 5.8496 0.21755 +6448 4 49.1634 15.9354 37.7317 2.81773 -6.75889 -8.88584 +6449 4 49.3364 16.2327 39.1899 -1.1635 1.82265 11.9188 +6450 6 15.9209 23.7098 13.4125 14.0576 3.0382 28.6395 +6451 4 16.4576 23.7581 14.2247 -6.14337 -14.5589 -15.9509 +6452 4 15.4928 24.5639 13.4473 -12.8057 7.70559 -12.0572 +6453 6 14.3535 29.1644 14.3158 -5.44214 8.41065 -10.6214 +6454 4 14.1107 29.5404 13.4323 4.3831 -8.60004 22.5031 +6455 4 14.1668 29.874 14.9595 1.02369 -3.68708 -8.8215 +6456 6 30.4209 19.8501 16.8941 13.513 -29.8099 -4.40702 +6457 4 30.8419 19.6061 17.7309 -1.16118 4.00396 0.0836579 +6458 4 29.8867 20.6126 17.0073 -13.0379 22.0094 6.56408 +6459 6 21.3171 21.0315 23.1347 13.77 4.04154 19.3244 +6460 4 22.2214 21.2364 23.4619 -15.8088 -1.32345 -6.31481 +6461 4 20.7299 21.1568 23.8987 5.07857 1.54253 -3.54042 +6462 6 32.3393 0.431439 25.2563 20.1104 -9.0179 2.05206 +6463 4 32.3376 0.357033 24.2893 -5.83171 4.85221 4.50445 +6464 4 31.4939 0.740536 25.5658 -20.5297 5.12544 -3.04931 +6465 6 26.1412 32.4208 27.5133 11.9844 8.82666 12.5058 +6466 4 25.6297 33.2181 27.3271 -3.7928 0.326337 -6.17907 +6467 4 25.9506 31.7475 26.8638 -6.12498 -3.36782 -14.5181 +6468 6 31.6886 23.0183 41.4596 0.904697 7.64904 11.3452 +6469 4 32.5758 22.6752 41.6838 -11.075 0.532718 -2.08438 +6470 4 31.0649 22.7115 0.227606 5.71652 1.16966 -4.3825 +6471 6 54.3662 17.838 10.7289 1.16641 13.6113 28.4031 +6472 4 53.5784 18.2682 10.4091 -15.835 11.3767 1.3744 +6473 4 54.5574 17.2244 10.05 12.0924 -25.2322 -22.7117 +6474 6 15.4007 28.5656 8.62044 -26.1749 5.76845 -41.3303 +6475 4 14.7273 28.9702 8.01425 13.7656 -2.21873 23.1298 +6476 4 15.8479 27.9621 8.001 5.22436 1.48231 12.0756 +6477 6 21.9302 22.318 27.6758 1.68517 -22.7815 -10.3197 +6478 4 22.2029 23.2377 27.6948 5.32233 7.77922 8.4028 +6479 4 21.9507 21.9579 28.5708 1.77406 4.33165 6.10734 +6480 6 2.9439 17.0434 8.14058 1.94164 -24.3442 -12.3304 +6481 4 3.71771 17.0381 7.53295 -10.9103 8.58946 10.7103 +6482 4 2.9095 17.8301 8.67828 12.1388 15.179 1.9509 +6483 6 27.5776 18.2769 3.9771 26.0492 -34.2565 5.18616 +6484 4 26.8914 18.9079 3.85686 -19.1066 25.6869 -8.0303 +6485 4 28.3968 18.6065 3.57961 -12.2542 3.89161 2.52414 +6486 6 24.7648 24.5394 8.45172 0.675902 5.99664 -6.73781 +6487 4 25.0691 23.6382 8.29185 0.995795 -2.08458 0.0885467 +6488 4 24.6379 24.6158 9.40394 1.7631 1.80546 -0.516948 +6489 6 41.9985 30.4652 13.7873 -12.418 22.2399 8.0521 +6490 4 42.948 30.5766 13.6065 -4.54142 -18.1038 -0.632901 +6491 4 41.6543 29.5567 13.7855 17.2179 -0.450275 -1.52495 +6492 6 15.7003 34.688 41.5836 22.5583 -4.71252 2.77114 +6493 4 16.4414 35.3131 41.7067 -7.89455 1.74939 1.29748 +6494 4 14.9091 35.1782 41.7999 -10.5684 8.94915 5.66738 +6495 6 11.14 19.7709 40.5827 8.16812 -24.8495 -13.7269 +6496 4 12.099 19.6958 40.4335 -6.97557 5.6239 6.72769 +6497 4 10.8269 18.8658 40.3418 -4.09458 16.1616 8.77151 +6498 6 47.4994 34.5266 14.3059 -7.29954 -13.2064 -47.3862 +6499 4 46.9486 35.2618 14.0194 -1.26876 14.2822 14.9014 +6500 4 47.5134 34.0178 13.447 14.161 -1.19014 30.6955 +6501 6 12.4113 26.9599 28.4986 7.53387 -39.615 -11.3807 +6502 4 13.2389 26.8759 29.0383 -9.69033 -7.26437 -10.917 +6503 4 12.3547 26.143 27.8911 8.77392 33.3418 27.7102 +6504 6 27.6324 16.2078 39.8226 -15.7166 38.3334 10.2244 +6505 4 27.1738 15.4871 40.2515 -0.529449 -16.0233 0.418904 +6506 4 28.2783 15.8881 39.2072 13.4358 -18.0852 -11.4488 +6507 6 33.41 31.2223 27.2648 1.06056 32.1352 -34.8736 +6508 4 34.1408 31.8147 27.4795 4.37007 -7.45055 8.12396 +6509 4 32.9956 31.7298 26.5244 2.74339 -19.701 12.9858 +6510 6 39.1079 39.5697 31.9277 -2.55925 2.09297 0.92959 +6511 4 38.7672 39.6549 31.0188 2.43701 -1.71218 7.87361 +6512 4 38.6143 40.212 32.4659 5.60044 -5.69156 -1.85126 +6513 6 22.8777 16.5449 19.9566 -5.65986 -8.80894 -1.36967 +6514 4 23.3352 15.8067 20.4264 -14.7096 4.17994 -10.0586 +6515 4 22.0919 16.2116 19.4632 15.4216 -6.99735 9.66589 +6516 6 23.9693 21.8661 10.5894 -36.2244 3.36606 3.40233 +6517 4 22.9782 21.9097 10.6297 20.8239 3.29656 -5.85881 +6518 4 24.1356 21.2379 11.286 10.3432 -8.66819 12.8402 +6519 6 40.1777 25.441 2.79106 -10.2872 18.2283 6.37262 +6520 4 40.1705 25.0132 3.63888 8.49445 -17.5146 10.0011 +6521 4 39.7592 26.2809 3.01477 -1.02299 2.45309 -8.63041 +6522 6 15.0237 19.7749 9.41859 -29.0071 17.4399 5.80075 +6523 4 14.7228 20.7104 9.1599 7.38 -34.1593 9.70733 +6524 4 14.2459 19.2857 9.84339 25.5779 21.3804 -17.4983 +6525 6 7.16152 24.8628 0.123297 -7.02966 -3.56682 11.7049 +6526 4 7.96668 24.8036 41.5398 15.214 -7.46464 -23.6733 +6527 4 7.46323 25.2953 0.914133 -6.27594 4.44234 13.0485 +6528 6 43.3927 10.9201 31.3407 25.4071 10.106 7.84859 +6529 4 43.8098 10.8609 30.45 -7.40798 -0.791197 19.4909 +6530 4 44.1598 10.9733 31.9767 -21.009 -0.343387 -21.8186 +6531 6 13.8353 19.068 27.8558 -6.19586 12.3763 0.85665 +6532 4 12.975 18.7858 28.1864 -1.64107 2.23065 2.52451 +6533 4 13.8413 20.053 27.8412 2.88957 -13.8419 -2.19198 +6534 6 3.4728 19.5924 9.6022 -44.5705 9.69836 1.75794 +6535 4 2.70361 20.0095 10.0844 20.5969 -13.9146 -9.89239 +6536 4 4.25765 19.8234 10.0844 13.5534 0.0599395 5.99295 +6537 6 51.0213 19.4268 7.70955 2.43945 12.0622 -23.2725 +6538 4 50.6325 20.2627 7.28999 21.6228 -31.5555 10.1722 +6539 4 51.8004 19.115 7.16203 -27.7652 18.9123 7.69536 +6540 6 42.2139 2.59999 10.4154 11.3377 -7.01405 -0.847173 +6541 4 43.144 2.57533 10.7556 -19.516 1.89174 -10.2127 +6542 4 42.1979 2.39197 9.45142 9.27815 6.14572 20.7298 +6543 6 30.7794 6.42968 35.1975 -13.4378 -7.3385 -2.08895 +6544 4 29.8146 6.43175 35.3648 9.73054 -4.02703 -1.93701 +6545 4 31.052 5.50707 35.0427 -6.67101 6.52405 0.860042 +6546 6 52.8733 36.9495 18.5906 -4.95733 10.1612 -6.16245 +6547 4 51.9909 36.5548 18.5738 -2.549 -5.51132 1.40056 +6548 4 52.7192 37.8514 18.247 7.64894 -10.0112 4.74408 +6549 6 44.2058 6.2999 1.04709 5.21291 8.10008 11.2107 +6550 4 44.5368 6.97198 1.69742 -2.24215 -10.2401 -12.34 +6551 4 44.9393 6.09517 0.464894 1.54959 1.89788 1.1267 +6552 6 42.1369 38.61 31.1886 17.67 -9.24899 26.4806 +6553 4 41.7623 38.8803 30.3687 -14.3725 6.55505 -24.001 +6554 4 41.498 38.8614 31.8609 -3.32676 4.75778 -0.202389 +6555 6 43.7164 12.7972 9.05712 5.81528 3.72875 -30.711 +6556 4 43.3247 13.6946 8.89573 9.87346 -21.9812 3.16194 +6557 4 44.14 12.4709 8.19462 -12.6006 16.8915 32.7492 +6558 6 13.3844 0.443398 6.51083 -17.4423 24 5.83044 +6559 4 13.1471 1.18968 7.12521 11.9969 -17.0568 -16.1514 +6560 4 13.404 0.824606 5.60344 -0.330864 -2.32474 10.3957 +6561 6 16.1322 13.2809 10.2756 -7.67495 0.483234 -7.74316 +6562 4 16.9315 12.7781 10.4995 -2.28882 -8.98658 -2.43525 +6563 4 15.4389 12.669 9.92885 16.2568 3.72445 6.60733 +6564 6 1.59909 8.47465 4.69565 -12.106 -24.0688 17.9122 +6565 4 1.97809 9.06493 4.05503 13.7499 12.9224 -12.6029 +6566 4 2.17818 8.51684 5.47441 1.43398 4.73372 -5.14276 +6567 6 37.2847 1.71984 10.5234 11.0189 -27.5723 -13.4042 +6568 4 37.2468 2.67416 10.4778 -4.00861 9.27523 10.0347 +6569 4 36.8996 1.35439 11.335 -2.27729 16.2243 3.90618 +6570 6 53.8329 9.87891 17.6846 -38.3798 -30.924 7.14602 +6571 4 54.5301 10.0186 17.0634 18.0368 1.02749 -18.7159 +6572 4 53.3473 9.06138 17.3773 12.8854 20.2391 7.24153 +6573 6 45.4804 30.6107 15.8042 -8.04753 0.598448 7.23065 +6574 4 44.8245 31.2304 16.205 12.7241 -16.0174 -7.51778 +6575 4 45.2045 29.6903 15.9459 -0.384376 11.4708 0.631615 +6576 6 39.9212 16.643 33.8508 -27.7636 -7.17353 -19.4615 +6577 4 39.1766 17.1755 33.458 21.1378 -12.4278 10.7513 +6578 4 39.8244 15.7487 33.4296 5.23768 21.8708 14.061 +6579 6 32.8655 24.7639 27.9361 20.284 59.6053 -7.49862 +6580 4 33.6165 25.1458 28.4374 -8.60268 -19.6727 -0.650124 +6581 4 32.6313 25.5876 27.4183 -1.69816 -34.155 10.7383 +6582 6 7.87466 31.6143 24.1101 1.9117 20.6925 26.3443 +6583 4 7.66972 30.8573 24.7192 5.27436 26.873 -8.7819 +6584 4 7.9908 32.4716 24.6533 -12.57 -44.6195 -20.0842 +6585 6 43.5378 41.3358 15.8218 9.28004 -2.58796 -1.50951 +6586 4 43.1443 0.2957 15.6997 -2.19094 2.48586 -2.7957 +6587 4 44.4004 41.3722 15.3768 -7.99823 -0.449815 2.36698 +6588 6 20.0371 29.5453 33.205 3.08504 -20.5033 -11.6211 +6589 4 20.9096 29.2965 33.5637 -2.90058 10.2459 9.35691 +6590 4 19.6251 30.2513 33.706 8.84517 7.80605 8.87396 +6591 6 43.4117 21.4438 18.6347 -11.1342 -15.0059 14.8538 +6592 4 43.0276 21.2687 19.5098 8.56326 4.46648 -0.801958 +6593 4 42.8532 20.9111 18.0542 1.01153 2.95656 -9.2223 +6594 6 3.44653 19.1197 18.4217 23.6769 1.99723 9.81042 +6595 4 3.20802 20.045 18.3207 -2.32682 2.96104 -2.33529 +6596 4 2.63398 18.6303 18.3598 -12.7596 -8.76931 -2.32568 +6597 6 41.6678 38.1102 16.3244 12.531 -42.2252 -39.0953 +6598 4 41.9368 37.3879 15.641 -15.3799 38.9729 30.6603 +6599 4 42.3331 38.0554 17.0146 -0.0757724 1.18921 2.99625 +6600 6 7.55561 36.3978 10.4983 -3.44092 15.1931 -1.45671 +6601 4 6.72339 36.2337 10.0108 12.3142 -8.52859 4.51616 +6602 4 7.946 35.5335 10.7116 -10.6452 2.04557 -4.50299 +6603 6 36.2515 19.1074 34.8142 -43.7142 -17.0801 -27.3746 +6604 4 35.3817 19.3303 34.3863 23.1726 -6.06315 12.306 +6605 4 36.4633 19.8781 35.3097 10.3 22.3537 14.1292 +6606 6 53.5678 24.9372 12.6442 30.4342 18.5181 -32.2976 +6607 4 53.8348 25.8921 12.6266 -11.9077 -21.6197 10.5864 +6608 4 54.0165 24.5977 11.8224 -16.4724 -4.37861 26.9125 +6609 6 31.6766 10.443 21.0806 4.21881 -9.06253 -2.47208 +6610 4 31.4001 9.76622 21.7243 -7.70504 9.2495 -8.08332 +6611 4 30.9288 10.6617 20.4921 1.78432 -8.02731 8.28605 +6612 6 18.1094 28.7798 17.1891 14.7524 22.0605 -19.6834 +6613 4 19.0758 28.769 16.9872 -20.2742 -2.10771 9.28657 +6614 4 17.7731 29.5847 16.7123 5.43167 -23.0331 15.3038 +6615 6 21.675 18.2354 36.8765 16.12 -15.5286 8.52342 +6616 4 22.5529 17.9072 36.565 -22.4082 10.693 4.11156 +6617 4 21.5572 17.762 37.7329 -6.04816 8.67317 -10.9669 +6618 6 25.0658 19.0188 34.2159 -51.8076 2.97265 19.7815 +6619 4 24.747 18.4039 34.9114 5.38902 10.2451 -10.362 +6620 4 25.8774 18.6629 33.96 52.7001 -22.9877 -15.275 +6621 6 15.5692 13.0234 5.56242 -6.58245 2.44228 -13.4315 +6622 4 15.9945 13.4237 6.33643 -0.981395 -11.5063 2.18089 +6623 4 15.4281 12.0558 5.58603 5.20341 13.6823 8.40676 +6624 6 54.4716 41.6235 14.8012 14.2089 2.8312 2.80672 +6625 4 54.7869 41.5367 15.7234 -10.706 -4.16636 -8.71187 +6626 4 53.6678 41.1066 14.6963 -6.31993 -3.99892 7.53898 +6627 6 1.6781 26.4654 31.3743 5.67012 -21.4195 51.4057 +6628 4 2.55869 26.331 31.7713 -6.41431 -1.4007 -7.54986 +6629 4 1.81482 26.7235 30.4972 11.6805 15.9936 -52.9786 +6630 6 32.3382 37.285 29.6856 -26.7217 17.5069 7.43983 +6631 4 31.5807 37.8924 29.918 20.5429 -15.6126 -5.39856 +6632 4 33.128 37.6701 30.0913 2.74033 -1.11204 0.131524 +6633 6 52.7155 21.0369 22.8986 -26.6856 13.1044 -7.83906 +6634 4 51.927 21.5218 22.5308 17.9584 -10.8856 16.9396 +6635 4 53.1096 20.6236 22.131 10.0871 -9.76004 -3.40095 +6636 6 32.7546 28.5936 40.5151 -16.005 5.57574 20.6704 +6637 4 31.9696 29.0914 40.2712 1.08408 5.35728 -15.103 +6638 4 32.4826 28.2925 41.3957 13.2257 -7.23298 -6.66392 +6639 6 23.6064 32.0719 16.3529 6.2601 0.887785 0.577407 +6640 4 24.375 31.9361 16.9584 -22.6405 4.1158 -3.2487 +6641 4 22.7879 32.3052 16.8361 12.3926 -5.56708 -0.502672 +6642 6 37.5201 9.16809 29.9792 -2.73778 -7.47015 7.66604 +6643 4 36.7801 8.78215 30.4957 3.311 11.363 -11.2805 +6644 4 37.2059 9.98527 29.541 -5.1069 -9.85197 8.55889 +6645 6 2.27705 24.391 14.5477 -18.8311 -23.8216 -15.5117 +6646 4 1.75426 24.0938 15.3142 10.0576 11.8704 2.19803 +6647 4 1.95568 23.7778 13.8474 11.5886 17.7779 11.9828 +6648 6 27.3753 28.7961 24.7726 7.21008 -25.2057 -20.8265 +6649 4 27.1644 28.4274 25.6317 -2.92196 -0.0765173 10.3399 +6650 4 27.4291 28.0161 24.1505 1.02404 24.316 14.9 +6651 6 16.7879 2.56531 14.3086 11.9129 14.2285 -1.69346 +6652 4 17.7185 2.38196 14.3175 13.0278 5.32386 8.84309 +6653 4 16.4775 1.81817 13.8231 -22.7045 -15.6449 -12.1127 +6654 6 21.8022 39.8027 36.8001 40.4582 11.674 1.33338 +6655 4 22.755 39.5599 36.9347 -17 12.4394 -0.288792 +6656 4 21.461 38.9709 36.5396 -21.7153 -28.8447 -11.0269 +6657 6 14.0716 6.47232 41.542 21.0202 -14.2424 -6.97231 +6658 4 14.9696 6.10406 41.5939 -1.81915 -4.72532 -7.76656 +6659 4 14.0403 6.99701 0.421866 -13.8031 9.98176 13.4178 +6660 6 14.5555 16.5106 9.31543 20.3876 4.44524 4.12907 +6661 4 15.4025 16.5964 9.78828 0.864554 -6.42184 -12.9633 +6662 4 13.9847 17.046 9.86181 -12.8914 3.93145 3.80898 +6663 6 8.66171 23.4817 30.5575 -0.244333 -0.896371 32.8135 +6664 4 9.54353 23.6001 30.2398 18.7576 4.73722 -27.2602 +6665 4 8.85707 23.3999 31.5064 -16.6456 -3.41855 -0.290363 +6666 6 37.6497 2.07069 20.0046 29.2824 -26.1096 14.9164 +6667 4 37.0584 2.2163 19.2662 -13.6051 13.4744 -1.64318 +6668 4 37.4656 2.68422 20.7276 -9.488 6.31449 -9.7769 +6669 6 42.7264 7.54802 8.0174 22.2735 -23.3375 63.966 +6670 4 43.1898 7.96838 7.30926 14.9789 10.8108 -11.9713 +6671 4 43.3711 7.43923 8.8454 -34.4126 10.1207 -51.4479 +6672 6 38.5672 29.6578 6.85692 25.3422 5.29964 1.58487 +6673 4 38.5311 29.2984 7.75245 -9.71234 0.328663 -2.10015 +6674 4 37.7248 29.5682 6.41889 -15.2832 -4.18317 0.54199 +6675 6 42.5348 15.7114 39.7967 1.15785 13.3588 -25.5786 +6676 4 42.7129 16.6429 39.5831 1.88136 -1.51067 11.9166 +6677 4 42.2359 15.3735 38.9271 3.70013 -4.77916 17.2749 +6678 6 19.8546 7.43685 22.0566 -22.5975 2.81071 25.7956 +6679 4 19.2803 8.13273 21.6746 8.521 -7.13733 1.21439 +6680 4 19.4015 7.21173 22.9242 12.7412 8.86068 -31.9054 +6681 6 27.421 3.23371 12.5304 27.0524 21.0752 -24.489 +6682 4 28.3367 3.35644 12.1327 -27.9555 -7.8832 14.1518 +6683 4 27.3543 2.31638 12.8154 4.42645 -1.52034 -0.990676 +6684 6 34.4011 6.50186 34.3664 -16.3424 -2.90191 9.94761 +6685 4 33.6712 7.15225 34.4215 6.78416 -7.62851 1.00734 +6686 4 34.1394 5.7575 34.9538 2.66911 12.7001 -5.69623 +6687 6 9.88701 27.9536 39.7574 38.1218 -1.21446 9.36845 +6688 4 10.8313 27.9815 40.1009 -35.4969 -5.93471 -11.3457 +6689 4 9.7403 28.8357 39.397 -3.9481 4.17466 -3.11552 +6690 6 50.5681 22.1235 6.40489 -3.33101 1.51672 6.50125 +6691 4 51.5163 22.3536 6.46403 -14.0562 3.33212 10.0382 +6692 4 50.0608 22.5915 7.10741 15.6039 -2.37345 -9.267 +6693 6 47.1098 11.477 30.0359 32.4056 2.61276 18.961 +6694 4 47.3696 10.9259 30.8115 -10.3246 7.95021 -16.9085 +6695 4 46.3045 11.1726 29.6407 -20.48 -14.5539 -1.24473 +6696 6 25.9367 28.4654 9.80931 -8.38409 -27.2904 31.5361 +6697 4 26.8395 28.2564 10.1264 -14.1867 1.81997 -4.27567 +6698 4 25.3175 27.9176 10.3882 19.4096 21.4407 -17.1039 +6699 6 35.4417 36.6052 19.4431 3.65383 9.51374 12.5698 +6700 4 35.4442 36.5892 20.4356 4.35023 4.13201 -20.4161 +6701 4 36.0823 37.2978 19.1702 -7.18083 -5.57131 7.61291 +6702 6 39.0947 17.861 12.3005 -1.37104 18.7141 6.38745 +6703 4 39.0516 18.8013 12.5757 6.4741 -5.57949 -8.41576 +6704 4 38.3925 17.481 12.8252 -9.64523 -10.3587 5.73293 +6705 6 2.67895 27.1328 2.39169 -0.469231 -1.96621 -7.87892 +6706 4 2.01695 27.5866 1.84113 6.06579 -3.44887 4.00529 +6707 4 2.54603 27.3828 3.31988 1.36543 -1.57126 -4.01383 +6708 6 12.3125 32.2183 21.5204 7.73608 31.3279 -34.5621 +6709 4 12.8754 32.1648 22.302 -15.5368 -9.13091 6.69049 +6710 4 11.4514 31.7997 21.5885 -0.151568 -8.94455 23.3893 +6711 6 32.8824 32.3641 8.46179 -18.8611 4.30442 3.1153 +6712 4 33.4241 32.9657 8.96292 17.2175 7.79223 5.74753 +6713 4 32.0088 32.7748 8.50666 0.635289 -6.40729 -7.5616 +6714 6 12.649 6.44414 31.9754 -2.83404 4.50046 10.0363 +6715 4 13.204 6.32185 31.2101 8.19857 -2.9014 -11.0209 +6716 4 11.7563 6.235 31.704 -2.09981 -3.08597 -3.85403 +6717 6 41.3663 27.7408 14.044 -7.1512 -14.0341 -18.9391 +6718 4 41.8178 27.3798 13.2339 -12.2472 13.3456 19.5442 +6719 4 40.4043 27.5413 13.9741 19.5004 0.843126 1.31278 +6720 6 6.61204 16.505 25.4358 4.38086 10.1107 -4.22872 +6721 4 7.40634 15.95 25.3995 -3.52048 -0.326181 -5.74655 +6722 4 5.93615 16.0015 24.9584 5.4209 -2.01242 3.85811 +6723 6 21.7595 39.2992 13.3504 -47.5104 6.20728 42.9111 +6724 4 22.3466 39.2605 12.6295 26.4998 6.28224 -34.1528 +6725 4 21.7095 40.2078 13.7281 10.6984 -16.5323 -14.9329 +6726 6 34.8487 6.01484 6.95222 -29.6963 0.326386 -14.1862 +6727 4 33.862 5.88861 6.88689 25.1099 2.0969 11.0318 +6728 4 35.0754 6.24807 6.0365 6.49139 -1.48305 5.74594 +6729 6 33.0274 30.4243 33.1708 -20.2868 -13.6057 -33.0226 +6730 4 32.107 30.5622 32.8069 24.6222 -1.48625 15.7647 +6731 4 33.1252 31.0225 33.8918 -2.19017 18.1524 16.6028 +6732 6 15.459 32.4153 12.1907 25.026 -14.7999 12.6103 +6733 4 16.3707 32.0454 12.2858 -22.5133 7.43237 -2.39957 +6734 4 15.4871 32.8857 11.3664 4.63911 10.1509 -16.175 +6735 6 12.6896 26.6018 21.3639 -15.0944 -25.6853 -2.70918 +6736 4 11.948 26.0906 21.6799 0.937138 -29.673 -19.3981 +6737 4 12.542 27.2759 21.9777 19.0907 58.813 21.5342 +6738 6 47.0229 36.3064 29.9951 -7.32095 -4.41829 24.4392 +6739 4 47.4263 37.0889 30.4354 -10.9743 -13.05 -1.23566 +6740 4 46.4286 35.8162 30.6445 23.161 23.2616 -16.2608 +6741 6 0.29284 12.714 23.4069 -35.5625 7.7859 6.41586 +6742 4 0.591011 11.8915 23 -3.04289 0.952694 -0.179009 +6743 4 54.2726 12.6526 23.4069 36.7156 0.482893 -0.227565 +6744 6 54.1717 18.9252 21.5683 -50.0663 20.0699 0.290361 +6745 4 -0.00468748 18.6783 21.9698 30.2345 -16.5238 -1.58257 +6746 4 54.0846 18.73 20.626 15.626 -5.42297 0.74208 +6747 6 25.7258 24.2992 23.7444 19.803 -45.4072 -0.235584 +6748 4 25.1532 23.5493 23.4006 14.0979 28.9064 13.4272 +6749 4 26.557 23.8171 24.0636 -29.432 23.3848 -10.2309 +6750 6 11.8983 29.0288 26.8736 6.09277 -0.515715 3.71925 +6751 4 12.595 29.6797 27.0784 -3.35093 -5.68029 1.25498 +6752 4 11.9864 28.3255 27.5444 1.01315 10.8055 -7.75858 +6753 6 47.9911 35.8567 10.6981 8.08413 -4.02984 -21.6227 +6754 4 48.7745 35.7734 10.1229 -13.6418 -1.85084 -2.1863 +6755 4 48.3792 36.2903 11.4463 -1.30569 7.34959 21.4512 +6756 6 47.672 29.8438 36.9511 38.562 -32.0587 -16.7646 +6757 4 48.1514 29.311 36.2244 -26.8687 25.3781 26.6073 +6758 4 46.9232 30.3209 36.5927 -0.690739 -0.634879 -8.58348 +6759 6 7.33835 12.3416 10.615 -8.89583 -3.33234 -10.1121 +6760 4 7.22469 12.7824 9.73793 -1.24183 -8.23722 19.221 +6761 4 6.50851 12.5236 11.1156 17.4449 -0.896679 -14.5349 +6762 6 52.929 15.961 4.90278 -10.2898 -1.28264 -8.50781 +6763 4 53.0348 16.1145 3.95774 -1.18717 -0.815743 4.35872 +6764 4 53.806 16.0238 5.26597 15.814 -0.370642 9.21047 +6765 6 10.6777 16.9586 34.6035 -55.1347 -38.7426 5.67968 +6766 4 10.8984 16.7766 35.5088 23.7364 14.024 15.8473 +6767 4 9.8802 16.3472 34.5582 30.0556 27.9196 -18.3163 +6768 6 25.1377 31.056 36.0048 1.42921 -10.848 -28.6765 +6769 4 25.7744 31.7772 36.0714 -0.417948 1.95283 3.18329 +6770 4 25.3475 30.6244 35.1463 -8.66047 8.51414 18.9355 +6771 6 34.0941 21.8921 41.4705 -2.59948 8.49748 21.8065 +6772 4 33.8376 21.0023 41.2487 -0.891159 -17.6747 -3.00217 +6773 4 34.5263 22.2081 40.6953 10.3371 11.5397 -24.1167 +6774 6 15.7674 30.0637 1.25444 19.4532 4.17941 -23.0135 +6775 4 15.204 30.4318 1.91689 -16.4157 4.77211 21.8875 +6776 4 16.1981 30.8773 0.915598 -5.77798 -19.2538 1.08217 +6777 6 29.5177 27.8662 16.6069 -21.9867 -20.8772 26.8051 +6778 4 29.4575 26.8938 16.8925 2.72258 42.9501 -5.19299 +6779 4 28.8337 28.3532 17.1557 16.905 -14.8206 -13.8895 +6780 6 39.6418 9.77683 0.55649 6.97543 15.8838 23.3716 +6781 4 40.1108 10.6055 0.868863 -11.4024 -23.0197 -7.66085 +6782 4 39.4946 9.23542 1.36828 3.21978 8.9832 -14.2415 +6783 6 1.52158 31.8692 16.4183 -13.8984 7.04184 27.8471 +6784 4 2.05742 32.2974 15.7673 16.5414 8.9668 -16.2997 +6785 4 1.54493 30.9444 16.2035 3.31157 -20.7597 -8.56027 +6786 6 8.73651 39.8559 25.0424 -4.76165 -15.5453 0.0774869 +6787 4 8.05377 39.648 25.6948 0.177415 -5.7342 -2.33302 +6788 4 8.86744 40.7877 25.1714 9.39418 20.2019 -3.50565 +6789 6 42.3206 10.2864 9.76098 2.95973 19.1246 -1.63703 +6790 4 42.201 10.133 10.7061 4.21692 -0.996774 -0.328573 +6791 4 42.7677 11.1578 9.6855 -5.09192 -13.1904 -0.0451331 +6792 6 13.2407 7.61713 1.96996 -7.39862 -1.41628 8.88927 +6793 4 13.9913 7.91748 2.51852 -7.45732 -2.50241 0.703823 +6794 4 12.5579 7.21318 2.54911 15.3337 9.06064 -6.21655 +6795 6 18.7418 40.0591 14.2229 14.6643 6.60726 6.61579 +6796 4 19.3344 39.8885 14.9901 -13.3575 3.17545 -12.3588 +6797 4 17.9636 39.4956 14.2872 3.6042 -5.87931 7.54738 +6798 6 20.1073 14.0529 38.5598 27.8117 -61.2518 1.76132 +6799 4 20.1641 13.6472 37.6602 -4.05869 13.902 17.7453 +6800 4 19.784 14.907 38.4293 -21.3136 56.4597 -12.4562 +6801 6 22.6529 28.8869 34.0687 6.58134 -12.6264 20.4136 +6802 4 23.051 28.2341 33.486 -0.980474 2.102 -8.59088 +6803 4 22.967 28.5961 34.9503 -6.50134 7.38476 -6.63172 +6804 6 22.6736 4.71248 5.24178 -0.00794307 -2.96021 -16.86 +6805 4 22.1728 3.90748 5.48978 2.26378 16.1145 9.27739 +6806 4 22.7088 5.35566 5.95806 -4.05577 -5.29394 11.9552 +6807 6 23.6374 34.0001 38.3917 50.061 26.1352 -20.3518 +6808 4 22.8137 33.6238 38.6177 -41.7704 -11.5062 -0.965889 +6809 4 23.6153 34.3835 37.4812 -9.56218 -11.3792 16.4738 +6810 6 48.3816 21.3644 17.2759 -0.964958 21.4078 15.1884 +6811 4 48.1603 22.346 17.2347 5.31328 -30.3781 -7.15015 +6812 4 48.2799 20.9337 16.4123 -2.86285 15.3202 1.32987 +6813 6 11.5786 11.0066 8.63803 -22.8025 30.9503 41.2381 +6814 4 11.6342 10.2487 9.24135 6.24209 -4.12245 -6.65597 +6815 4 11.0653 11.6976 9.17674 20.0011 -23.9124 -25.5895 +6816 6 40.098 28.1667 33.502 25.4322 5.13826 0.328547 +6817 4 41.0532 28.3457 33.4282 -8.43417 -7.39989 8.78785 +6818 4 39.8078 28.5143 32.6608 -12.8477 1.2165 -2.93222 +6819 6 47.3852 25.6796 5.28879 12.5804 32.9376 -10.0311 +6820 4 46.4546 25.5561 5.13624 -16.8804 -10.2001 -0.268496 +6821 4 47.5232 26.6241 5.03253 2.87445 -14.5067 3.75712 +6822 6 21.6604 35.221 23.9985 9.0652 15.9564 -12.6156 +6823 4 21.5339 34.4977 24.6161 5.50034 -7.33202 6.93593 +6824 4 22.5891 35.5406 24.0132 -10.9025 -9.97729 6.37443 +6825 6 8.25067 41.5023 8.40693 4.57396 0.593767 -7.67714 +6826 4 8.14583 40.8128 7.73311 1.23406 2.32353 -0.157563 +6827 4 7.86929 41.1416 9.20784 -2.18245 3.41182 6.12515 +6828 6 16.4756 31.0916 22.2208 -15.8048 -5.76047 -3.57767 +6829 4 16.9823 30.8797 21.4186 0.224111 -1.11381 3.57708 +6830 4 17.0871 31.1495 22.9566 10.3822 -1.94934 1.40451 +6831 6 54.7052 0.441622 28.3216 30.4392 7.42547 7.16367 +6832 4 0.670225 0.280878 28.2941 -2.60978 -25.0778 -11.1355 +6833 4 54.7831 1.35385 28.5964 -22.0828 12.0381 3.63841 +6834 6 48.4365 15.3814 4.18175 16.1137 -59.8395 -8.29881 +6835 4 49.2486 15.0627 4.66696 -19.7577 20.5705 -9.22457 +6836 4 48.202 14.5739 3.61717 1.65501 39.0327 16.4105 +6837 6 34.3447 6.98096 40.4233 28.1894 -26.1309 -0.966046 +6838 4 33.5941 7.1072 39.8443 -1.28272 -2.58724 -7.46065 +6839 4 35.0352 6.39393 39.9745 -30.768 20.5054 8.50532 +6840 6 41.3452 3.36617 16.9999 -11.8967 -16.9054 2.63506 +6841 4 41.0249 2.72492 17.6694 2.1854 6.18106 -7.89089 +6842 4 41.9449 3.92974 17.49 7.08552 9.22633 4.28017 +6843 6 48.4488 20.6937 14.5344 36.1561 -40.2628 27.2518 +6844 4 47.9962 21.3635 14.0898 -25.7182 45.1623 -29.349 +6845 4 49.3977 20.8911 14.4834 -7.22111 0.680744 -3.09477 +6846 6 52.5006 28.1422 37.1181 -0.438891 10.9489 1.55023 +6847 4 53.461 28.2559 37.0441 -2.53591 -5.73983 -7.32344 +6848 4 52.1579 27.9957 36.2188 6.05301 2.29627 6.02383 +6849 6 53.8778 18.5596 18.7916 -16.4261 -54.6782 2.06415 +6850 4 54.6924 18.1462 18.492 5.89253 -2.608 -0.931268 +6851 4 54.0684 19.4623 18.7843 11.279 55.5152 0.463912 +6852 6 40.9954 39.1455 28.7887 -28.6383 -4.85259 53.4888 +6853 4 41.3933 39.2419 27.9663 30.849 7.00679 -57.5311 +6854 4 40.0484 39.2316 28.6375 -4.32997 -1.25138 -0.266272 +6855 6 38.2708 8.75593 24.2289 27.2886 -4.9888 -5.43324 +6856 4 39.2171 8.59021 23.9715 -26.3742 3.09491 7.04217 +6857 4 38.3303 9.34105 24.9905 -3.83131 2.71498 5.53525 +6858 6 2.99948 29.1469 9.63392 26.6909 -34.1608 2.5373 +6859 4 2.51216 28.7995 8.89273 -4.75194 -2.8028 -9.24178 +6860 4 2.58111 29.9575 9.82954 -15.8869 33.6035 13.3424 +6861 6 27.5773 29.2771 18.3181 4.27818 -11.5166 33.1226 +6862 4 26.7531 29.1546 17.8331 -9.3021 -0.872639 -4.78576 +6863 4 27.3558 28.9731 19.2647 9.0806 12.9475 -44.783 +6864 6 11.8527 21.1658 10.1208 3.44892 -32.1211 19.512 +6865 4 12.1978 22.0146 9.89711 8.39983 22.4635 -8.03232 +6866 4 12.4593 20.8304 10.8135 -12.0936 9.66798 -13.0295 +6867 6 16.8988 32.3014 0.299949 1.29982 1.68058 -0.586211 +6868 4 17.7043 32.7282 0.600499 13.9817 -1.747 3.00212 +6869 4 16.3216 33.0562 0.17902 -12.1561 7.80428 -5.7129 +6870 6 1.309 17.4831 22.5447 23.3848 -11.3219 -15.6007 +6871 4 1.13597 16.5744 22.1718 3.15619 19.2398 8.80125 +6872 4 2.27868 17.6899 22.4311 -25.7511 -7.40397 3.71946 +6873 6 41.5587 6.87311 29.3039 4.08196 29.5448 1.53382 +6874 4 41.6919 5.95311 29.5356 2.80206 -5.98386 3.69024 +6875 4 41.9106 7.40602 30.0483 -3.99043 -10.4039 -5.51054 +6876 6 10.5167 10.7886 13.8618 17.7458 -17.1897 13.2051 +6877 4 10.6632 11.2096 13.003 1.79898 0.261401 -4.84225 +6878 4 11.2159 10.1 14.0373 -16.1376 17.4326 -7.31573 +6879 6 39.8332 15.4952 40.8309 13.3581 4.75609 3.89566 +6880 4 39.9392 16.0809 40.0548 0.3292 -3.56753 7.15077 +6881 4 40.6564 15.5643 41.3732 -15.0531 5.58747 -11.8726 +6882 6 26.5094 19.6057 40.5003 9.17758 -2.41024 9.24949 +6883 4 27.4312 19.885 40.5187 -1.32295 2.31326 -8.74715 +6884 4 26.4504 19.08 41.3172 -10.7617 -0.025449 -2.36491 +6885 6 54.0331 8.19348 13.7645 20.1265 23.4755 -3.20859 +6886 4 54.5379 7.42769 14.0195 10.1236 -9.46733 3.3174 +6887 4 53.1635 7.89609 13.5919 -33.2862 -9.18344 -4.84573 +6888 6 15.685 25.3343 10.6639 3.77823 -5.01457 0.699023 +6889 4 15.2925 25.3549 9.7704 -6.94194 -0.507815 8.78718 +6890 4 14.9859 25.2981 11.3464 3.26271 -0.250944 -15.837 +6891 6 18.6044 3.42728 21.9359 54.0117 -4.17358 13.1129 +6892 4 19.6007 3.50499 22.1915 -55.8621 -1.2706 -18.0159 +6893 4 18.5414 3.70523 21.0018 -0.6471 0.781857 10.4283 +6894 6 50.8906 20.6382 18.514 19.322 19.8933 14.7131 +6895 4 50.0771 21.0514 18.1693 2.40506 3.30677 2.13188 +6896 4 51.4314 21.2881 19.0676 -26.3068 -18.4046 -20.3942 +6897 6 53.3692 20.9044 31.2861 -2.87581 -0.0590227 -4.61483 +6898 4 53.3163 20.8663 32.2507 -1.10677 -1.05899 -2.14121 +6899 4 52.4655 20.8115 30.924 8.48272 0.484508 7.85381 +6900 6 52.8175 27.637 28.9992 -34.1073 -16.3293 -5.23745 +6901 4 52.1753 27.4604 29.7292 18.9476 13.4611 -8.14668 +6902 4 53.5412 28.184 29.256 17.7352 16.912 19.7012 +6903 6 33.3098 15.691 11.3293 10.3241 5.44869 29.2776 +6904 4 33.5439 15.9761 12.2647 -8.49351 -12.0766 -30.078 +6905 4 32.4682 16.1118 11.1139 -1.38634 1.49203 3.14806 +6906 6 20.3823 26.792 27.4754 10.6616 14.7237 17.2289 +6907 4 19.6846 27.4135 27.2507 -4.69437 -0.849554 -6.03625 +6908 4 20.895 27.2908 28.1563 -10.3656 -18.3754 -15.2612 +6909 6 8.54404 2.05454 14.1651 1.1449 13.7122 2.29602 +6910 4 8.12946 1.19872 14.2191 -6.02545 -13.9865 0.607463 +6911 4 8.06484 2.58201 14.8308 4.74922 -3.38849 -5.44478 +6912 6 40.1105 7.56396 40.6794 -0.469697 6.72942 -1.63666 +6913 4 39.7195 8.28533 41.2425 20.0171 -18.0739 -7.27063 +6914 4 40.8018 7.03949 41.1472 -13.6242 13.5344 3.71207 +6915 6 6.897 6.83213 10.7811 7.71606 15.0782 -3.77655 +6916 4 7.19774 7.75246 10.6132 -6.74961 -17.2243 4.00207 +6917 4 7.00156 6.6927 11.7358 -2.06706 0.697676 -4.80225 +6918 6 31.2469 6.57665 20.133 15.2512 -44.8317 5.05575 +6919 4 30.6435 5.99888 20.634 -3.65198 3.16249 1.16613 +6920 4 30.7682 7.35458 19.9689 -22.0921 35.6742 -6.0398 +6921 6 54.5384 21.0446 27.3066 23.2273 -48.3206 40.5729 +6922 4 0.0992734 20.2122 27.4067 -21.2046 24.987 7.15799 +6923 4 54.6588 21.2398 26.4073 -2.82622 20.9035 -45.5707 +6924 6 4.74298 23.1434 16.2203 -30.2995 19.4891 -12.6787 +6925 4 4.36556 24.0555 16.215 7.46998 -18.526 0.357752 +6926 4 5.49124 23.2367 16.7883 23.1348 -5.45784 14.6166 +6927 6 25.5466 11.0338 14.8277 10.3359 0.700294 4.3384 +6928 4 26.1246 10.3443 15.2243 -8.70528 11.4294 -11.7317 +6929 4 25.9183 11.8873 15.0941 -0.865353 -5.34287 -3.41216 +6930 6 41.1962 41.784 29.9422 -30.017 -5.50367 -10.8152 +6931 4 40.9141 40.905 29.5845 10.5201 22.1914 8.67773 +6932 4 40.3904 0.453034 29.9085 19.4524 -11.6054 2.3136 +6933 6 52.2783 15.2862 41.6211 7.07203 -4.19206 -10.8941 +6934 4 51.9431 15.9476 0.307056 -1.67854 11.1856 8.97788 +6935 4 51.5699 14.6487 41.5543 -8.05659 -11.9472 -4.98288 +6936 6 37.758 21.7866 37.8526 10.4754 12.291 4.40187 +6937 4 37.8833 20.8525 37.7239 2.64231 -18.5298 -3.43162 +6938 4 38.1062 21.9123 38.7409 -0.189838 4.59809 2.45253 +6939 6 23.846 9.72877 27.5599 -20.0483 -53.0743 -18.3837 +6940 4 23.7508 8.9538 26.878 9.78252 41.145 35.6193 +6941 4 23.2758 9.50619 28.3397 9.82275 7.24107 -18.911 +6942 6 43.0179 28.0371 32.8168 -8.27592 12.0689 -0.875134 +6943 4 42.8326 27.1827 33.2413 14.9994 1.75302 -2.99965 +6944 4 43.9358 28.1723 32.5349 -8.32605 -13.2452 6.20231 +6945 6 34.1493 21.223 11.895 -6.4617 -26.4803 6.62596 +6946 4 33.7114 20.3967 12.2433 5.74917 23.5867 -12.2191 +6947 4 33.6625 21.5015 11.0997 -1.34318 -2.64619 5.02085 +6948 6 10.5048 31.8203 10.0934 3.12763 27.8567 -5.97475 +6949 4 10.8893 32.6663 10.3856 -2.25958 -16.5293 2.97323 +6950 4 10.042 32.0955 9.27903 1.62317 -10.8132 6.61598 +6951 6 35.8582 37.1311 22.1219 17.442 6.8165 -15.3109 +6952 4 36.7754 37.4644 22.0121 -13.2022 -8.29883 -6.66499 +6953 4 35.6795 37.2674 23.0383 -11.5038 0.0185045 25.2366 +6954 6 27.2889 4.59659 27.4585 -59.4895 -12.2555 32.2126 +6955 4 27.8503 4.63259 28.2407 7.94553 1.46958 -1.61102 +6956 4 26.3513 4.38137 27.8533 49.6255 8.2673 -26.6042 +6957 6 39.0071 22.2889 10.6559 -18.7539 6.55471 8.53947 +6958 4 39.6145 22.0219 9.97399 11.0637 -4.63202 -10.5583 +6959 4 38.132 22.2267 10.2407 1.98377 -6.13574 3.6668 +6960 6 30.7475 39.195 10.9378 13.4076 -25.4475 -2.13886 +6961 4 31.7135 39.1987 10.9202 1.84768 25.2682 1.10777 +6962 4 30.6542 38.2342 10.8274 -15.9936 9.0572 -1.5893 +6963 6 44.6038 26.9469 2.19596 -3.02312 -2.7981 0.496435 +6964 4 44.789 26.0668 2.58199 4.34993 15.1048 -14.5643 +6965 4 45.3477 27.2287 1.63769 1.54159 -5.20589 8.29494 +6966 6 23.7761 14.5574 26.4892 -1.60295 28.5342 -20.4107 +6967 4 23.6176 15.1119 25.659 4.49284 -25.3407 28.839 +6968 4 23.2395 13.7622 26.4238 -2.18231 -2.53609 -2.40557 +6969 6 38.3444 13.3746 39.6516 36.4054 -1.80378 3.51049 +6970 4 39.1202 13.8805 40.0461 -33.1028 -11.4882 -12.1373 +6971 4 37.5326 13.855 39.8351 -2.35218 5.60767 6.28087 +6972 6 17.8972 17.2344 29.4073 9.50877 -9.96512 10.1834 +6973 4 17.6974 16.8197 28.5593 -3.90288 0.722299 -3.3346 +6974 4 17.259 17.9348 29.5179 -13.7448 8.39178 0.729907 +6975 6 17.4263 29.84 9.91085 4.63967 13.4244 18.4952 +6976 4 16.5241 29.7155 9.63978 -6.68442 -7.79832 -10.641 +6977 4 18.0121 29.6473 9.18714 6.17675 -5.88453 -9.84082 +6978 6 35.6257 6.05657 19.614 -2.53427 -7.67526 1.74575 +6979 4 35.1442 5.56448 18.9178 7.07991 15.7277 0.668344 +6980 4 35.8526 6.94177 19.2847 -2.44106 -6.98166 -5.33042 +6981 6 18.6731 22.2952 17.5195 -8.35574 4.99894 -0.254983 +6982 4 17.7298 22.4259 17.6349 -7.1371 0.699885 10.6378 +6983 4 18.7532 22.3981 16.578 9.97204 2.32932 -16.3296 +6984 6 20.0126 3.82895 32.2846 -5.38506 7.6032 10.998 +6985 4 19.7316 4.05659 31.3951 3.95105 0.959407 -6.40709 +6986 4 20.9087 3.45699 32.2166 -3.62371 1.18893 -2.87546 +6987 6 5.48106 6.97474 8.11911 -13.3431 -28.5569 -4.23146 +6988 4 5.76723 7.87539 8.05126 9.5873 19.9723 5.64469 +6989 4 5.84003 6.56862 8.91875 4.365 4.20298 7.41399 +6990 6 44.2055 20.527 25.594 -36.5422 -32.7496 -22.1294 +6991 4 44.4952 21.1964 26.2048 27.2712 12.1663 0.509182 +6992 4 44.8136 20.1687 24.9192 13.264 16.717 13.5958 +6993 6 43.9676 36.9898 17.8707 9.43563 13.9581 11.3899 +6994 4 44.6425 37.4866 17.3506 -13.9886 -14.2814 1.04264 +6995 4 43.5166 36.316 17.3518 1.57776 -4.71986 -9.07493 +6996 6 34.624 10.1249 16.2553 -3.80507 -0.870494 -23.8528 +6997 4 34.4029 10.0232 15.2766 7.60873 7.05542 33.3523 +6998 4 34.6485 11.0843 16.4397 0.136369 -4.79707 -6.11079 +6999 6 23.6588 3.43472 1.31587 2.0947 2.20184 -10.1691 +7000 4 23.5283 2.45383 1.23665 3.68597 29.2686 -10.0862 +7001 4 23.7829 3.95594 0.465507 -5.48879 -27.0668 21.3429 +7002 6 33.408 38.9514 5.0951 12.9752 29.4037 8.61745 +7003 4 33.0296 38.079 4.95882 -18.4714 -2.71742 3.9597 +7004 4 32.7559 39.6696 5.33685 4.56028 -29.4715 -9.24259 +7005 6 22.5612 32.5054 35.7914 -7.59797 17.3543 -6.08959 +7006 4 23.434 32.1498 35.9581 8.59623 -0.183209 1.98348 +7007 4 22.6598 33.4814 35.6698 2.01652 -18.126 2.22848 +7008 6 32.4197 37.2669 13.8205 20.7322 22.1346 -9.91782 +7009 4 31.6112 36.8955 13.5272 -29.3682 -10.7083 -8.61391 +7010 4 32.7793 36.5983 14.3861 8.71878 -17.2052 10.8721 +7011 6 52.6061 12.7509 39.5955 -8.08982 -5.36768 -0.728302 +7012 4 53.2357 13.3696 39.2333 6.80499 9.05338 -6.44134 +7013 4 53.0752 12.2813 40.2869 4.34006 -2.9945 3.85342 +7014 6 28.8406 14.5639 1.22393 13.2702 13.2594 -7.07732 +7015 4 28.2547 13.832 1.29641 -8.98786 -23.9917 -3.18497 +7016 4 28.3081 15.2705 1.57856 0.691728 8.20301 3.76967 +7017 6 1.46371 32.4171 23.3808 -12.1734 -25.5645 13.9938 +7018 4 1.52421 31.5049 23.0145 7.51613 19.861 -1.66683 +7019 4 1.90409 33.05 22.8306 10.4998 5.06095 -20.3958 +7020 6 54.3326 23.3294 28.9734 2.61182 15.3833 -1.51239 +7021 4 54.2696 22.9227 29.8387 -0.130455 -4.55084 5.05008 +7022 4 54.4476 22.6226 28.3359 -0.0534198 -9.82677 -0.516761 +7023 6 14.3165 12.143 35.6759 -19.2415 -8.81627 -0.503167 +7024 4 14.3877 12.7977 36.3527 0.233596 18.6669 11.2481 +7025 4 15.2077 11.8775 35.5438 25.0768 -7.98239 -7.51161 +7026 6 18.9926 6.51479 41.2701 -28.9824 -29.6237 1.81046 +7027 4 18.266 5.84223 41.3522 13.7729 17.3268 -5.20094 +7028 4 19.3309 6.57432 0.258232 8.64619 7.1183 4.95474 +7029 6 5.3156 17.8978 20.3375 -21.1545 16.5991 3.60383 +7030 4 4.72623 18.3448 19.6879 4.29754 -5.05212 8.41069 +7031 4 4.82948 17.9368 21.1935 9.1049 1.98802 -15.8618 +7032 6 24.7216 34.9676 30.1666 -3.07326 -14.2394 -14.8574 +7033 4 24.8542 35.9126 30.1802 4.14387 12.0412 4.3338 +7034 4 24.7023 34.7085 29.2239 -0.0690866 8.67132 12.606 +7035 6 31.8759 4.61762 18.1838 16.2734 -6.94643 -1.61547 +7036 4 31.7767 5.32612 18.8146 -0.693712 9.66586 8.6442 +7037 4 30.9961 4.53608 17.8264 -12.7431 -2.99311 -6.3499 +7038 6 8.70679 17.4876 5.93376 -7.2594 15.0659 3.57914 +7039 4 7.94553 18.1226 5.84491 19.4684 -9.25267 2.2845 +7040 4 9.55198 17.9922 5.98984 -15.4384 -2.82622 -0.0668602 +7041 6 29.8338 10.9771 14.4736 2.85583 -20.8689 4.17621 +7042 4 29.3487 11.4359 13.7779 -2.35633 12.0716 2.99849 +7043 4 29.9333 11.5067 15.2792 -5.11986 9.15119 -1.36774 +7044 6 48.7176 10.2992 32.5766 37.752 -4.2965 -7.5649 +7045 4 48.6861 9.98692 33.5109 4.36425 8.41374 -15.5521 +7046 4 49.6689 10.1741 32.2115 -43.6207 3.75412 17.6406 +7047 6 8.33261 15.6868 37.8739 25.2856 -16.7599 -34.932 +7048 4 8.10095 16.0156 38.719 -17.2941 17.7495 29.2541 +7049 4 7.84865 16.1686 37.1872 -4.77393 6.83012 10.4818 +7050 6 50.4 3.07893 17.326 6.75193 2.54677 -10.5223 +7051 4 49.8476 3.08454 16.5614 0.0537611 0.514048 -24.7797 +7052 4 49.7563 3.22783 17.9993 -5.52918 6.4504 35.6689 +7053 6 14.6925 38.3995 10.8943 -10.4545 -11.2686 -1.07851 +7054 4 14.3539 38.6226 11.7634 0.533319 14.8424 10.3104 +7055 4 14.2274 37.5681 10.7419 5.82896 -0.087222 -8.72758 +7056 6 34.1157 6.37736 10.827 20.4112 17.5403 9.63945 +7057 4 34.1356 7.15575 10.2337 -4.79421 -13.4894 2.09643 +7058 4 34.9392 6.47467 11.3721 -17.4677 -2.57189 -8.67394 +7059 6 7.16428 37.5549 17.6272 35.8206 -6.94283 1.42456 +7060 4 8.17672 37.4379 17.5039 -45.4701 3.04153 9.54579 +7061 4 6.9329 37.0909 18.4673 4.48983 7.2965 -12.9876 +7062 6 51.5173 11.3068 16.7982 -29.6345 12.4732 -19.9425 +7063 4 52.2329 10.8476 17.1999 24.0623 -16.8016 7.00331 +7064 4 51.4947 11.1437 15.8343 5.46468 -1.37513 9.57578 +7065 6 15.6604 8.64432 3.1895 3.55656 -13.2601 -18.336 +7066 4 15.3831 9.26805 3.84437 -11.3932 20.6181 15.5674 +7067 4 16.2117 8.03967 3.68493 6.317 -8.49687 -0.892024 +7068 6 5.4241 21.4549 11.925 7.11554 10.6798 -7.02681 +7069 4 5.33432 22.3429 11.4717 -4.65036 -17.889 17.4658 +7070 4 4.77116 21.2815 12.6313 -0.367847 15.68 -7.67111 +7071 6 50.1893 24.0442 37.9781 -13.1484 0.855785 -17.0816 +7072 4 49.5179 24.1845 37.2801 8.13829 0.111989 16.6227 +7073 4 50.739 23.3224 37.6715 2.2014 -1.01472 3.1635 +7074 6 39.7382 11.2507 31.6977 23.6406 7.23187 -3.58891 +7075 4 40.4046 11.8538 31.2923 -18.8268 -10.2166 5.80002 +7076 4 38.8713 11.6238 31.5229 -1.54541 8.70996 -4.13134 +7077 6 26.6923 10.8294 20.5841 1.50171 17.3672 -0.163562 +7078 4 26.3063 11.3901 21.299 5.00814 -17.7696 -11.6362 +7079 4 26.5519 9.91114 20.8376 -1.99146 -0.979444 5.82041 +7080 6 12.5744 17.5779 18.1705 9.62673 -31.396 -11.9521 +7081 4 12.2909 16.663 17.987 19.11 1.74385 -8.92353 +7082 4 11.8345 17.8227 18.6757 -30.0259 29.7826 25.4081 +7083 6 47.7778 31.6094 17.3292 -7.10666 -17.038 -8.06235 +7084 4 48.347 31.2547 18.014 2.28217 1.30733 4.94459 +7085 4 47.3418 30.8212 16.9416 1.10301 17.3121 -1.07651 +7086 6 1.06524 3.39018 18.5298 -14.3894 10.3619 10.5476 +7087 4 1.40487 3.81402 19.3241 14.4239 4.64695 -0.395869 +7088 4 0.13491 3.28998 18.7837 -2.56119 -4.67364 -10.5163 +7089 6 26.5953 20.387 15.3121 4.86749 -24.5982 -5.101 +7090 4 27.0693 19.5476 15.0746 -6.18915 17.8108 6.48343 +7091 4 25.6882 20.059 15.4501 7.15985 4.40883 -1.86988 +7092 6 42.0068 3.03472 36.7639 -8.02624 -14.3838 3.82934 +7093 4 41.5138 2.21919 36.6422 -1.8797 -9.24856 -19.1073 +7094 4 41.9017 3.12445 37.6992 6.42334 14.3979 20.8626 +7095 6 39.3283 22.4329 33.1866 16.7976 22.9312 16.1168 +7096 4 39.617 22.6043 34.1233 -9.1007 -15.4059 -24.4851 +7097 4 39.2996 23.351 32.8579 -1.9326 -13.3537 -7.72798 +7098 6 18.5014 34.9723 11.9503 -40.872 8.93582 -22.0032 +7099 4 19.313 34.895 12.3871 37.9781 -3.12322 33.9295 +7100 4 17.8134 35.1232 12.6133 -0.0311416 1.40314 8.7121 +7101 6 22.862 14.1089 0.203393 17.2545 -2.37957 19.5806 +7102 4 23.1276 14.8054 41.5255 0.219481 9.03583 -13.3452 +7103 4 23.4003 14.3117 0.999915 -8.23864 -6.67581 -7.59618 +7104 6 30.9898 16.6325 33.7811 -26.24 4.82889 -18.7278 +7105 4 30.4991 16.9295 32.9906 -1.06726 -7.21679 15.5744 +7106 4 31.8724 16.8786 33.545 20.2345 1.84197 6.64809 +7107 6 28.4142 35.5086 5.55132 5.25795 11.5001 -0.86936 +7108 4 29.133 34.8901 5.6729 7.87573 -11.0207 0.32142 +7109 4 28.8444 36.3678 5.44284 -5.96253 -1.38672 0.306744 +7110 6 2.06178 31.4487 10.6522 7.7724 2.5252 5.43788 +7111 4 2.46787 32.1741 10.1582 1.48866 -1.05725 0.00513454 +7112 4 1.12423 31.5492 10.4902 -10.7705 -1.69396 -4.48797 +7113 6 5.96168 9.75465 21.3469 -3.89643 8.81348 -50.5901 +7114 4 6.28958 10.5041 20.7544 -9.04712 -29.7196 22.9081 +7115 4 5.37557 9.21645 20.7377 15.5825 17.9805 22.1648 +7116 6 24.7784 26.6095 2.66066 11.1746 -2.24162 5.28408 +7117 4 23.9956 26.7754 2.10108 -2.29597 -10.0774 9.56872 +7118 4 24.6953 25.8682 3.30791 -10.2989 11.7132 -14.8816 +7119 6 45.7373 4.24983 18.6143 27.3178 -0.763462 -4.2154 +7120 4 46.5067 4.85242 18.4954 -19.0177 -2.03966 3.70694 +7121 4 46.1538 3.38182 18.4484 -14.6954 3.88493 3.6473 +7122 6 4.46307 0.776675 15.9004 -0.0751459 19.7124 -7.24544 +7123 4 4.28648 41.7452 15.8506 7.90268 -11.6504 4.49907 +7124 4 5.34722 0.941656 16.2766 -7.84 -9.44871 -1.18019 +7125 6 2.43543 19.4835 25.3975 -8.02289 7.34849 22.5637 +7126 4 1.8039 19.0427 26.0095 9.34608 -2.48106 -16.7091 +7127 4 2.63666 18.9452 24.6346 -2.8512 -10.1259 -3.82486 +7128 6 40.5893 8.48301 5.11314 -1.35782 -12.8068 -2.32465 +7129 4 40.7524 9.27543 5.61119 -3.30667 17.7402 10.4879 +7130 4 41.4486 8.05286 5.16027 3.34022 -8.8045 -8.92488 +7131 6 49.3107 22.3512 41.5276 -10.6582 56.3201 6.76971 +7132 4 48.577 22.7852 41.0387 15.264 -8.60422 5.01334 +7133 4 49.2575 21.458 41.2835 -0.448838 -46.7272 -11.6484 +7134 6 0.358901 40.9209 20.5803 -19.8443 -5.20423 -21.0143 +7135 4 0.209912 39.9476 20.5616 0.00996972 10.506 -0.843682 +7136 4 54.6254 41.351 20.0384 15.1519 -13.0167 14.2251 +7137 6 34.868 15.3449 38.0159 -4.77394 11.9701 -21.6163 +7138 4 34.21 16.0699 37.905 14.1938 -11.5268 -7.28032 +7139 4 35.478 15.4115 37.2329 -18.0572 6.07255 16.3223 +7140 6 7.76403 26.0071 29.8556 5.34791 -0.957035 4.21351 +7141 4 8.62364 26.4528 30.0224 -8.82329 -12.5157 -0.945539 +7142 4 7.90301 25.0604 30.0866 1.23738 19.4493 -2.25897 +7143 6 40.714 22.798 20.4449 30.2403 28.6605 -20.1452 +7144 4 41.3584 23.4838 20.081 -22.4198 -29.1089 11.875 +7145 4 40.2102 23.3285 21.0558 -12.075 4.18803 12.4472 +7146 6 37.6868 25.6422 36.0641 6.66209 -5.59755 13.6904 +7147 4 38.2808 24.8923 36.0269 4.65063 -3.44496 7.57849 +7148 4 37.3429 25.6351 35.1859 -16.0941 8.70932 -25.1352 +7149 6 5.45062 23.9828 10.2587 5.16865 5.9624 5.01697 +7150 4 5.97911 23.8188 9.45867 -6.21725 4.51436 8.29683 +7151 4 5.82702 24.8173 10.6422 -10.2102 -24.7042 -13.9856 +7152 6 48.3972 21.0585 38.1887 36.079 14.8531 -15.9941 +7153 4 48.9083 20.6932 38.9203 -9.15007 -3.24726 4.47194 +7154 4 49.1186 21.3212 37.5505 -33.8036 -6.43701 14.9947 +7155 6 15.2894 25.0118 3.53737 -15.5341 -16.8072 10.9824 +7156 4 15.3523 24.0463 3.54635 7.80908 -0.218079 -10.1213 +7157 4 14.6524 25.152 4.25109 -0.971191 12.1275 -1.41446 +7158 6 46.3973 40.2818 20.0864 -5.10979 -28.8528 0.810189 +7159 4 46.7099 39.3289 20.1836 -4.69047 35.7762 -3.66479 +7160 4 47.1343 40.8792 20.2285 11.4236 3.93541 -0.385178 +7161 6 34.6613 36.4755 0.335066 -24.7851 30.4749 -21.6933 +7162 4 34.8743 36.0541 1.15687 -4.43901 -4.57192 24.0914 +7163 4 33.7851 36.9546 0.454416 30.1492 -20.7825 2.99091 +7164 6 52.5881 7.99834 30.4195 9.51271 -12.4348 0.483116 +7165 4 52.1042 8.76616 30.7719 -8.49213 -7.21741 -10.9068 +7166 4 52.0722 7.46347 29.7764 0.520668 12.6171 10.1624 +7167 6 32.0714 3.86484 29.4697 -9.7538 -17.9077 -31.6249 +7168 4 31.6702 2.97314 29.6052 7.93851 20.6113 2.31556 +7169 4 32.0839 3.94733 28.4741 0.539668 -3.17995 32.4864 +7170 6 20.3786 17.8365 28.6466 -12.59 16.0252 -12.2548 +7171 4 19.5397 17.5939 29.0718 10.0495 1.57584 1.91854 +7172 4 20.0545 18.3008 27.843 10.529 -6.18443 10.1885 +7173 6 30.4085 41.1704 41.0135 6.18506 -3.22706 -14.2809 +7174 4 30.53 40.7341 40.1581 -10.3332 2.11637 -0.589059 +7175 4 31.2241 40.9477 41.4498 10.7912 2.88832 12.9661 +7176 6 35.4567 32.8541 27.9296 20.1033 20.3116 -25.2142 +7177 4 35.1103 33.2872 28.7174 -1.27312 4.66796 4.01126 +7178 4 35.9087 33.5476 27.342 -15.0191 -24.2746 21.4934 +7179 6 14.3794 6.67806 12.7301 -1.9413 28.2373 -4.00169 +7180 4 15.2373 6.26429 12.8613 2.01848 -2.11516 -0.858514 +7181 4 14.5332 7.65903 12.7289 -3.54891 -27.4927 -2.87641 +7182 6 41.884 41.5441 20.3292 17.5267 3.97767 -7.39307 +7183 4 42.6467 41.3531 19.7473 -6.80228 5.43899 6.41045 +7184 4 41.2989 40.8038 20.1922 -8.54368 -4.96293 -3.75352 +7185 6 46.4016 22.5784 8.86191 7.75251 -10.6521 7.11129 +7186 4 45.8476 21.8716 8.52158 -12.3576 2.35246 -8.51817 +7187 4 47.0146 22.0703 9.39636 1.75986 6.35736 5.22437 +7188 6 17.4049 20.6472 13.8946 9.03444 14.2526 1.49725 +7189 4 17.6929 21.5842 14.0543 -8.3446 -25.4959 -7.46489 +7190 4 17.3265 20.4984 12.9333 2.034 6.01629 5.63707 +7191 6 8.18883 9.49722 13.352 -36.2403 7.79383 -0.838203 +7192 4 7.38606 10.0563 13.5919 32.9103 -12.129 -3.09847 +7193 4 9.02271 9.90793 13.6245 -5.40631 9.4956 5.41337 +7194 6 7.5857 14.8045 29.5864 0.660595 8.18183 -2.22865 +7195 4 7.08502 14.4366 30.3218 -1.52277 2.83209 3.37304 +7196 4 7.02502 15.474 29.1565 2.15616 -5.78955 1.98978 +7197 6 29.5787 39.2199 22.642 -23.9064 2.77655 4.40715 +7198 4 29.7923 38.7231 23.4359 12.3113 -5.95711 5.92816 +7199 4 30.3289 39.2945 22.0576 16.6647 -3.01011 -3.30282 +7200 6 19.7261 28.8048 8.43629 7.07867 10.1416 -1.30332 +7201 4 19.5094 27.8711 8.56662 5.24428 2.50367 -2.7317 +7202 4 20.6808 28.8901 8.64157 -12.3267 -4.04756 -0.658665 +7203 6 20.0918 21.6433 25.9098 -22.8378 18.9737 -2.62589 +7204 4 20.6828 21.9331 26.6394 -14.5657 0.991195 -11.6344 +7205 4 19.2872 22.2354 25.9429 24.6623 -16.2361 5.64257 +7206 6 12.7798 16.1171 22.7918 2.83481 -1.66518 -8.4999 +7207 4 12.1052 16.761 22.5802 -5.26913 11.1277 0.000470885 +7208 4 12.4145 15.3113 22.3987 5.67676 1.62415 3.74644 +7209 6 7.09341 27.2127 17.9852 -17.6727 17.6357 -2.43489 +7210 4 7.71878 26.5086 17.8851 15.5779 -18.3258 -2.50971 +7211 4 7.24623 27.7931 17.2297 2.82114 0.873921 -0.89624 +7212 6 32.4121 8.69011 34.8574 -11.3856 31.068 25.9423 +7213 4 32.686 9.10208 35.716 -2.62469 -14.8204 -24.695 +7214 4 31.4981 9.04705 34.7249 20.8054 -13.4625 -4.53694 +7215 6 50.3489 28.2274 17.5408 2.96892 -19.9668 3.87059 +7216 4 50.2931 27.3328 17.9381 -3.71715 13.2344 -0.552608 +7217 4 51.012 28.0828 16.8476 -2.81747 8.99858 -3.49204 +7218 6 15.6752 32.1523 25.7996 -24.1097 -1.02752 -8.0065 +7219 4 16.4469 32.5721 26.1513 19.1192 7.47953 7.03048 +7220 4 15.1241 32.8942 25.4834 5.39501 -5.59697 3.80799 +7221 6 41.2942 22.0009 29.6469 23.8016 -11.3242 12.4312 +7222 4 40.6197 22.5451 29.2897 -20.6362 19.5621 -14.8771 +7223 4 40.8321 21.2604 30.0334 -1.27155 -6.80964 4.85239 +7224 6 24.5512 12.7478 8.87624 0.539479 -2.56763 -16.1827 +7225 4 24.2317 13.5544 9.29419 1.48927 0.294937 0.678301 +7226 4 24.2485 12.8104 7.9491 4.47413 -5.17195 11.4459 +7227 6 47.3043 20.1171 10.4067 20.0451 13.2477 8.4905 +7228 4 48.2327 20.3756 10.3708 -0.951507 4.56311 9.88278 +7229 4 47.2371 19.5522 9.64912 -14.6685 -17.4861 -17.2657 +7230 6 17.6686 14.2187 29.9453 7.31834 -6.07886 -8.28437 +7231 4 16.8567 14.6777 30.1627 -12.3548 11.6861 -0.426412 +7232 4 18.1621 14.7508 29.3045 -6.68566 0.573373 4.02912 +7233 6 21.3468 34.5864 28.5404 1.3464 21.7174 -7.002 +7234 4 21.5866 35.4807 28.2285 -6.04705 -7.23946 1.73439 +7235 4 21.8012 34.5133 29.372 6.90897 -8.71765 12.9147 +7236 6 35.0919 4.05058 4.01374 -15.5825 9.30565 11.5721 +7237 4 34.2387 3.74233 4.43927 22.4566 16.9059 -11.4445 +7238 4 35.1406 5.04582 3.93988 -11.3656 -25.7387 7.52347 +7239 6 29.9083 8.58745 22.5962 -15.8002 1.46007 -28.7439 +7240 4 29.4293 8.33193 21.7391 23.5037 3.33824 36.5279 +7241 4 30.4512 7.83881 22.8901 -6.5033 3.48596 -7.29863 +7242 6 9.80484 32.9578 15.933 -3.40746 -8.77641 -12.0557 +7243 4 9.78146 31.9986 16.1651 13.0086 23.7442 4.23133 +7244 4 10.4547 33.4728 16.4465 2.19651 -19.1398 5.78046 +7245 6 24.9207 14.2283 32.5839 15.8568 -2.03515 22.8032 +7246 4 25.4679 14.491 33.3602 -10.7028 -6.65113 -14.6818 +7247 4 24.5651 15.0495 32.2637 -5.99659 7.67207 -7.30645 +7248 6 49.6599 21.9679 26.2292 42.3899 27.0609 3.31449 +7249 4 50.4576 21.5325 26.6526 -24.3124 13.7703 -9.69582 +7250 4 49.9726 22.89 25.9802 -16.6307 -33.6109 8.97028 +7251 6 39.2146 29.6271 28.776 1.2649 -6.72815 -4.66326 +7252 4 39.3113 29.0399 29.5368 -1.10705 1.67847 4.24024 +7253 4 39.5646 29.0864 28.052 -0.275695 2.9096 0.748968 +7254 6 50.692 34.7829 39.7485 29.9384 -8.83369 -9.14761 +7255 4 51.6379 34.6172 39.5245 -10.9597 10.0847 13.0799 +7256 4 50.284 34.1892 39.1195 -14.598 -6.88033 -5.74908 +7257 6 29.205 20.8761 19.5187 12.6622 -8.88768 18.517 +7258 4 30.1458 21.1462 19.5468 -10.0278 2.51211 -7.13483 +7259 4 28.7621 21.2804 18.7794 -5.02457 12.868 -15.5739 +7260 6 45.8413 1.41619 21.3894 -25.1775 13.0352 -19.0829 +7261 4 45.002 1.0285 21.6935 10.996 -3.183 3.42833 +7262 4 46.5512 0.981978 21.8333 16.3199 -17.0363 14.4799 +7263 6 26.0942 5.84138 12.9755 -8.81801 -1.79204 -2.94978 +7264 4 26.5644 5.00851 12.8396 1.48472 -6.22175 2.21387 +7265 4 25.1658 5.65249 12.7519 4.56693 -2.33816 -1.27821 +7266 6 9.00853 19.0479 23.7214 20.279 18.3012 -13.9253 +7267 4 8.07192 18.8993 23.8406 -12.3386 2.44029 -0.494901 +7268 4 9.09287 19.8709 23.17 -6.05991 -16.4473 11.9144 +7269 6 47.699 14.1778 40.0244 8.37408 5.46764 -8.11648 +7270 4 48.526 14.369 39.5365 -13.6583 -0.0280305 9.55934 +7271 4 47.2742 15.0291 40.2237 1.48315 -6.20176 -4.56159 +7272 6 47.9891 19.7944 0.501942 -52.5058 -34.5194 5.9677 +7273 4 48.5389 19.8149 1.25758 31.4646 9.24384 22.8657 +7274 4 47.3233 19.1101 0.79406 16.1078 24.936 -21.6052 +7275 6 27.1644 39.5895 31.4222 -35.4984 -42.2857 -13.2745 +7276 4 26.8828 40.2644 32.0188 2.45392 19.408 13.0965 +7277 4 26.334 39.0158 31.3353 32.2444 14.87 -2.1562 +7278 6 20.718 15.281 27.2921 -20.5288 29.0824 -25.1338 +7279 4 19.7916 15.5288 27.1303 0.0426049 -12.6319 11.5337 +7280 4 21.1251 16.0883 26.9354 13.4588 -8.377 2.43969 +7281 6 53.2931 3.12982 19.6939 21.059 35.3193 6.93312 +7282 4 52.5111 3.68486 19.642 -0.600406 9.66435 -1.15328 +7283 4 52.9649 2.26115 19.6482 -6.97037 -43.0252 -2.92507 +7284 6 40.7577 33.3874 24.037 12.7176 -1.25655 15.6318 +7285 4 41.575 33.1492 24.5319 -10.6485 3.51614 -11.0419 +7286 4 40.1417 32.64 24.1417 6.01104 2.31945 0.566227 +7287 6 50.2034 37.8915 21.3784 34.5696 42.4783 -9.46203 +7288 4 50.977 37.3667 21.5595 20.6596 -6.9612 4.63629 +7289 4 49.5128 37.3071 21.51 -51.1752 -39.6198 7.18684 +7290 6 41.3315 2.34663 21.9881 -5.34027 -0.787955 22.4754 +7291 4 41.3778 2.5308 21.0564 -4.51788 5.59338 -11.8441 +7292 4 40.4369 2.61524 22.307 16.348 -5.18373 -12.1741 +7293 6 3.68887 21.2797 14.3363 -13.7249 24.7693 -29.296 +7294 4 4.1389 21.9084 14.895 6.09004 12.6164 9.74183 +7295 4 3.85532 20.4521 14.7268 10.1618 -35.5887 19.7816 +7296 6 34.2749 11.1621 36.6211 6.86722 -26.3475 -8.98455 +7297 4 34.1457 10.3739 37.2084 1.76529 18.7936 -6.49638 +7298 4 34.0208 11.9523 37.0887 -10.0392 4.20616 19.2695 +7299 6 24.047 21.9251 23.4534 9.96695 -9.01801 9.45846 +7300 4 24.1056 21.4984 22.592 0.489969 -1.19981 -5.95122 +7301 4 24.6049 21.3417 24.0221 -10.3198 12.7259 -7.25629 +7302 6 18.8859 0.355593 4.41703 6.91373 -0.488994 13.8226 +7303 4 18.8848 41.346 4.15992 -3.4937 -3.21088 -8.69706 +7304 4 19.4141 0.350836 5.23016 -4.89519 7.76131 -7.17368 +7305 6 1.61894 7.82812 17.7388 11.0013 -2.20401 0.0755565 +7306 4 1.69825 6.91132 17.4299 0.598176 5.44338 0.144381 +7307 4 0.751076 7.92867 18.1276 -6.88769 -1.80246 0.772288 +7308 6 9.88357 31.5477 26.4865 20.7425 -47.9078 -25.9665 +7309 4 9.77347 30.8406 25.7562 4.13802 32.2768 29.9214 +7310 4 9.16637 32.1481 26.416 -28.5637 22.827 -5.6847 +7311 6 46.9801 33.0031 20.3665 8.92807 -2.6835 25.0439 +7312 4 47.1906 32.5959 21.2783 -12.5238 7.50902 -41.0074 +7313 4 46.473 32.3868 19.8049 3.08737 -2.68707 12.6131 +7314 6 49.5381 29.29 21.3848 5.35466 4.48298 6.61079 +7315 4 50.3596 28.8237 21.4263 11.6576 -22.6485 -14.6982 +7316 4 49.6544 29.7814 22.1942 -19.8316 15.0268 8.13943 +7317 6 13.5135 31.8933 19.1567 20.4477 19.0535 18.7588 +7318 4 12.9544 32.0303 19.9484 11.7182 -3.51681 -10.2564 +7319 4 14.3688 32.3555 19.4049 -26.6747 -15.4769 -10.5401 +7320 6 46.6242 34.0973 16.9259 3.25439 -22.1556 18.333 +7321 4 46.8986 34.1178 16.0034 3.18051 -0.659651 -5.23437 +7322 4 46.9878 33.2447 17.2966 -6.98741 23.2488 -14.973 +7323 6 19.7685 39.5238 2.42723 -1.93992 9.56528 -9.07466 +7324 4 20.504 40.1421 2.55739 -2.20075 -2.41675 -0.557551 +7325 4 19.2228 39.9982 1.75695 7.86662 -14.3322 13.7479 +7326 6 16.5372 9.39399 28.3106 5.81076 4.55242 0.698497 +7327 4 16.5228 10.3583 28.3138 -6.10914 3.2393 2.1867 +7328 4 17.4567 9.2086 28.1181 8.68803 -11.6531 -1.09187 +7329 6 3.04764 33.3834 8.9498 9.15555 8.47462 14.2626 +7330 4 2.34782 34.0603 8.86882 1.18173 -6.7492 -12.1187 +7331 4 3.16543 32.8691 8.13996 -9.91006 6.39371 -6.60301 +7332 6 49.6799 28.314 0.198287 -24.1009 9.02482 3.02524 +7333 4 50.5864 28.3416 41.8577 25.8797 -1.22492 -6.2647 +7334 4 49.539 27.5375 0.746128 -0.431885 -1.84115 5.43874 +7335 6 1.41501 6.84656 30.491 -4.80497 13.9866 22.936 +7336 4 1.80101 7.66454 30.873 3.64878 -10.2221 -13.1962 +7337 4 0.770406 6.61566 31.1883 9.6026 -0.286793 -13.8716 +7338 6 19.7721 9.41455 33.714 -8.86768 10.4812 -29.5452 +7339 4 19.9336 8.45599 33.7164 -2.74186 3.51224 -8.50186 +7340 4 19.4649 9.70036 32.7878 8.54711 -12.9815 34.2723 +7341 6 26.1689 11.9219 3.60877 17.3014 14.1658 -18.8808 +7342 4 25.6285 12.278 4.29668 -11.0155 5.7348 17.6305 +7343 4 26.0891 10.974 3.64129 -4.70103 -13.8965 4.54114 +7344 6 33.2526 2.15457 18.2061 -11.4346 36.8522 -3.73875 +7345 4 32.7853 2.99777 18.4754 10.6797 -23.9754 -11.6278 +7346 4 32.6748 1.45157 18.4903 -6.58847 -5.37306 4.71859 +7347 6 1.56641 29.1164 15.6218 -13.5802 38.9916 52.9136 +7348 4 0.75332 28.6899 15.9164 -2.28927 1.65734 -1.12046 +7349 4 1.88381 28.6368 14.9104 18.6776 -39.2188 -53.7174 +7350 6 41.7212 4.09992 39.5909 -11.2791 25.9615 -27.213 +7351 4 41.4168 4.81457 38.9155 6.653 -41.6332 33.8875 +7352 4 40.9635 3.53859 39.8438 1.60091 7.46224 -7.31473 +7353 6 28.6931 41.7984 21.1891 -6.68751 -8.42641 -4.80462 +7354 4 29.0735 0.780303 21.3271 9.25035 -16.558 -3.13259 +7355 4 29.3834 41.1221 21.0106 -2.7364 22.7931 4.70591 +7356 6 11.6395 12.4176 35.4525 -19.931 13.6599 -6.89173 +7357 4 11.6974 12.2316 36.3791 0.0383878 -4.43782 22.0781 +7358 4 12.5438 12.3774 35.1867 22.2579 1.64914 -11.6458 +7359 6 9.79005 12.0613 0.287125 39.0331 19.741 15.6941 +7360 4 10.6741 12.3652 0.649112 -24.288 -6.9143 -28.8601 +7361 4 9.37178 11.7496 1.07064 -16.9981 -12.0004 12.0483 +7362 6 48.1738 12.4001 9.21087 -14.7098 16.6281 -3.51107 +7363 4 48.3046 11.757 8.50338 5.36034 -5.93883 0.971929 +7364 4 48.886 12.3441 9.8545 11.7295 -7.72549 2.46367 +7365 6 20.1355 24.3829 18.9522 12.9308 -0.734849 -39.1055 +7366 4 19.4937 23.7815 18.5135 12.9255 8.80461 9.87411 +7367 4 20.8069 24.6162 18.234 -21.1698 -7.06963 26.7537 +7368 6 16.5393 31.2961 16.4761 -1.92172 -19.5246 -12.7122 +7369 4 16.66 32.2288 16.679 -4.64409 4.5232 17.4599 +7370 4 16.1207 30.7474 17.1716 1.36469 17.4989 2.94612 +7371 6 1.78169 14.6393 36.2977 19.9207 14.6923 -9.09136 +7372 4 1.03986 14.2937 35.8105 -15.9251 -7.35249 0.645581 +7373 4 1.68132 14.4688 37.2355 -8.64532 -4.94464 12.0587 +7374 6 4.36624 29.2084 29.5903 15.7403 17.1522 -11.4447 +7375 4 4.94475 28.7816 30.2313 0.42296 -3.8665 4.22363 +7376 4 4.9316 29.8996 29.1557 -19.5902 -17.4666 6.54186 +7377 6 43.6839 0.248111 22.6506 -19.7732 -13.3298 -9.50689 +7378 4 42.8764 0.661685 22.3065 0.028666 2.48852 1.60322 +7379 4 43.5183 41.2016 22.5042 11.2477 10.9397 1.57875 +7380 6 52.4994 40.9828 27.2386 -0.538127 -6.12089 -28.931 +7381 4 52.76 40.8447 26.286 -9.02638 3.90908 21.7421 +7382 4 53.2684 41.4137 27.6303 2.05735 4.02476 1.85103 +7383 6 25.5814 23.8969 27.7396 -24.7861 2.98762 0.531627 +7384 4 24.718 24.3642 27.6072 20.4038 -13.4527 4.15226 +7385 4 26.2821 24.4835 27.457 3.8963 1.45656 -1.88052 +7386 6 23.1228 17.031 33.3243 -5.52517 1.23961 5.4323 +7387 4 23.1399 17.5083 34.1558 0.441881 0.23205 -0.480567 +7388 4 22.8557 16.1383 33.5546 -4.67547 -8.64305 1.56256 +7389 6 2.92722 11.8725 21.3561 -41.4423 -19.1296 -19.7046 +7390 4 2.18606 11.2638 21.6443 29.5918 21.1066 -8.34803 +7391 4 3.54191 11.9259 22.0595 17.1072 -0.484489 21.5157 +7392 6 2.18317 4.15265 30.0257 5.779 -9.3787 -10.7468 +7393 4 2.12921 5.11001 30.0802 -2.76576 12.2821 -0.843831 +7394 4 2.67493 3.96573 29.2018 -3.29095 2.88479 4.98522 +7395 6 26.6728 30.2949 13.4768 7.17255 0.654769 14.1147 +7396 4 25.7117 30.2905 13.6467 8.22624 -2.44269 3.31295 +7397 4 27.1112 30.3188 14.3546 -11.9073 -0.623098 -17.8849 +7398 6 24.8734 30.8117 10.8292 -29.6944 -3.60301 -2.53615 +7399 4 25.2254 30.0431 10.3884 7.40196 -6.71761 -6.36825 +7400 4 25.5983 31.2424 11.2381 22.0508 11.6497 12.6203 +7401 6 53.1723 24.107 4.51212 -8.50651 -29.3458 16.902 +7402 4 53.5087 24.8189 4.00388 11.9327 21.9784 -14.7749 +7403 4 53.9335 23.6869 4.92936 2.49868 2.30602 2.88115 +7404 6 24.9006 4.49574 23.9943 -15.2803 12.8054 -1.91421 +7405 4 24.3197 5.26112 23.9044 -17.3839 -11.7779 6.16284 +7406 4 25.6928 4.95696 23.7819 42.3091 -2.82475 -3.31223 +7407 6 34.6808 1.64534 41.2582 -1.16689 -16.4189 -19.1193 +7408 4 35.6107 1.42238 41.0689 -7.35569 3.11738 8.02352 +7409 4 34.6894 2.06091 0.199506 5.11707 10.3461 19.9542 +7410 6 13.3318 19.5273 16.3875 10.456 -31.2285 9.008 +7411 4 13.8245 19.0713 15.6714 -4.89067 6.02882 4.66139 +7412 4 13.1633 18.7854 17.0362 1.8233 23.0525 -16.1268 +7413 6 48.6827 0.169575 20.4108 24.7259 -31.926 -14.6767 +7414 4 49.2893 41.6148 19.7702 -18.6338 21.3246 17.3218 +7415 4 48.933 41.6689 21.2514 -6.5025 5.85221 0.333279 +7416 6 43.0578 27.7881 11.5189 -10.6888 1.76469 -10.0665 +7417 4 42.6538 28.0077 10.6554 5.1393 -6.0393 10.108 +7418 4 43.5199 28.5835 11.7935 3.33621 0.984046 2.36511 +7419 6 25.7084 21.3766 35.1933 7.92601 18.71 -2.37973 +7420 4 25.8037 22.0957 34.5091 -5.30878 -22.9017 16.0752 +7421 4 25.4462 20.5484 34.7558 3.58761 11.0813 -0.636196 +7422 6 44.7325 4.60288 27.7529 -5.18995 0.47983 -9.95788 +7423 4 44.2388 4.02478 27.1463 1.34738 -4.40857 1.63455 +7424 4 44.3371 5.47709 27.6067 3.7052 -1.13476 4.16529 +7425 6 41.2786 11.441 34.2043 -0.416747 21.9122 -5.07112 +7426 4 40.7165 11.5703 33.4237 0.0697438 -4.14349 0.395824 +7427 4 41.2047 10.5155 34.4107 -4.51201 -19.8544 2.93408 +7428 6 19.8751 36.6454 2.03332 12.5662 31.6724 6.60432 +7429 4 20.6794 36.321 2.43856 -1.22315 -24.7147 -1.51883 +7430 4 20.0441 37.6041 2.15193 -20.0718 -8.75186 -9.57731 +7431 6 27.484 4.65653 6.35518 1.28922 -40.4385 -58.6648 +7432 4 27.5497 3.77116 6.72735 -1.75384 3.56143 11.9553 +7433 4 27.4257 5.33486 6.97498 -2.79123 31.4549 44.9969 +7434 6 16.8428 30.7659 39.9509 7.31092 -42.6244 -5.47757 +7435 4 16.9464 31.3097 40.7337 2.60533 1.47109 13.0941 +7436 4 17.1496 29.8303 40.1512 -5.48449 28.5555 1.20442 +7437 6 51.1542 15.2049 16.3406 35.1838 19.4064 -24.6303 +7438 4 51.2473 16.0791 15.87 -9.06363 -20.4986 13.944 +7439 4 52.0128 14.747 16.0894 -33.4595 8.32861 13.6861 +7440 6 49.9911 21.2271 35.9695 16.4294 -24.4585 13.2328 +7441 4 49.3547 21.5056 35.3276 -17.8928 6.13619 -17.6667 +7442 4 49.9245 20.2453 36.0087 2.29216 20.3869 -1.95357 +7443 6 34.4275 0.15221 5.68266 -0.837995 23.3079 0.855413 +7444 4 34.2957 0.929489 6.27037 2.93096 -11.6463 -16.4536 +7445 4 34.3488 0.459476 4.74482 0.623699 -7.30698 18.2278 +7446 6 48.316 11.5365 19.8846 -3.65813 -3.14803 11.8504 +7447 4 47.8503 11.3247 20.7373 6.31016 14.4835 -28.1035 +7448 4 47.7834 12.1052 19.2757 1.33379 -13.4076 20.6299 +7449 6 4.19577 39.4409 13.3607 25.3524 9.34899 10.5928 +7450 4 4.92582 39.74 13.9847 -33.0668 -7.48624 -17.3574 +7451 4 3.31127 39.5736 13.758 11.9971 1.78205 4.76714 +7452 6 8.7457 16.1809 8.53298 -1.62633 17.1572 -22.0575 +7453 4 8.74512 16.8853 9.19115 0.0519099 -7.3494 1.25428 +7454 4 8.72812 16.6658 7.66651 -0.023414 -16.7756 16.7144 +7455 6 29.0271 14.2712 26.5342 -13.8591 45.9397 20.1216 +7456 4 29.0757 15.2697 26.7309 6.93185 -43.1811 -12.6551 +7457 4 28.1042 14.0702 26.7795 9.9397 -3.04712 -3.53591 +7458 6 27.3813 14.5204 8.1419 -14.0666 1.8718 0.247246 +7459 4 26.4091 14.3966 8.10069 17.9482 5.30051 2.04476 +7460 4 27.5539 15.4689 8.31094 -4.76419 -14.5771 -1.3831 +7461 6 14.1301 27.2156 32.9232 24.3629 15.6041 -10.7258 +7462 4 14.926 27.3266 33.4685 -8.09546 -2.45296 -2.52419 +7463 4 13.4702 26.8045 33.4616 -14.5983 -10.6772 12.2116 +7464 6 31.6563 35.7792 21.2709 -29.1401 -25.1051 5.88501 +7465 4 32.0219 36.5153 21.7512 6.27263 14.1007 6.62418 +7466 4 30.8825 35.462 21.8184 22.9209 7.6802 -13.887 +7467 6 54.2186 28.7134 16.8958 -10.3287 11.0002 2.01575 +7468 4 53.5002 28.4234 16.309 3.24852 -2.61584 3.16662 +7469 4 53.9524 29.6107 17.1726 0.515277 -7.78004 -0.375364 +7470 6 9.0512 5.27483 17.1492 25.6572 1.38615 -17.9054 +7471 4 9.89534 5.12229 16.6101 -31.8522 3.085 22.1798 +7472 4 8.85255 6.23494 17.0921 1.81156 -15.0607 2.57474 +7473 6 29.6868 9.77258 26.5671 22.9889 -14.8503 10.4327 +7474 4 30.5444 9.2887 26.5838 -17.3341 11.3615 1.53321 +7475 4 29.3655 9.78642 27.4819 2.88877 -1.07091 -0.346791 +7476 6 44.0288 31.1766 32.1743 -14.2068 1.02328 22.4178 +7477 4 43.2475 30.9789 32.739 9.50682 -2.17476 -16.522 +7478 4 44.5788 31.7142 32.7564 8.88854 3.82935 -1.95952 +7479 6 53.49 3.62433 25.1454 11.2777 4.02107 -26.8953 +7480 4 54.1404 4.33507 25.1993 -2.49783 6.11479 15.045 +7481 4 53.6886 3.29227 24.2489 -10.294 -6.80459 12.4065 +7482 6 12.451 22.8746 3.38821 10.4278 8.96452 22.9237 +7483 4 12.7779 22.025 3.15024 17.1772 -24.972 1.67394 +7484 4 11.7815 22.9738 2.74712 -31.3784 16.165 -21.5343 +7485 6 39.42 29.6871 0.722943 17.2287 20.3893 -0.939439 +7486 4 39.938 29.1007 0.168548 -5.00448 -5.71086 -1.61555 +7487 4 38.6697 29.2119 1.03517 -14.5725 -11.7208 3.22357 +7488 6 13.7451 37.8179 23.0399 -3.65878 -32.3471 -6.65898 +7489 4 14.6418 38.0465 23.3627 -20.7195 15.519 -6.09735 +7490 4 13.1315 38.5597 22.9108 15.1185 11.2609 5.5967 +7491 6 33.3417 41.2334 -0.000336223 20.2285 27.8942 26.4667 +7492 4 33.8463 0.176253 41.7571 -17.5829 -26.3423 -4.93882 +7493 4 33.4991 41.0748 0.960438 -12.6248 -4.93214 -20.7453 +7494 6 15.7246 3.51737 6.33987 10.6879 -4.05507 31.4744 +7495 4 14.9251 3.29652 6.83809 -1.96505 1.65417 1.3128 +7496 4 15.4345 3.71468 5.4634 -8.944 6.24557 -22.4591 +7497 6 27.7713 30.7539 5.06912 -9.69485 -19.9648 -11.4393 +7498 4 28.5319 30.6575 5.66481 -7.77203 -4.90526 -3.90413 +7499 4 27.6074 29.8515 4.67882 9.36195 16.9347 11.4385 +7500 6 13.3277 7.57287 23.3467 18.1651 -5.37845 17.9429 +7501 4 14.1986 7.86136 23.0073 -11.0143 -2.49266 1.50668 +7502 4 12.7134 7.55433 22.6278 -8.93981 2.52131 -14.7715 +7503 6 38.3049 37.3174 27.9983 8.70135 -12.5747 15.655 +7504 4 38.3154 37.3922 27.0572 -6.74668 8.75695 -30.2201 +7505 4 39.0324 36.7087 28.1704 1.61648 -2.88985 11.5174 +7506 6 35.8266 12.5392 12.0897 -2.57405 -7.53067 12.8361 +7507 4 35.6491 11.5922 12.0112 2.97069 1.46586 -4.70523 +7508 4 36.2655 12.8127 11.2954 6.10525 2.83369 -11.8718 +7509 6 52.1153 23.0889 41.2774 53.3714 4.98692 -14.9993 +7510 4 52.5505 23.0114 40.3503 -31.9828 -2.74691 35.5054 +7511 4 51.1752 22.9201 41.2974 -16.3051 -5.99839 -13.4785 +7512 6 39.5458 11.6586 16.6081 -4.87816 2.10267 -34.9091 +7513 4 39.8889 10.7596 16.6462 4.61035 -3.54577 11.4771 +7514 4 39.4661 12.017 17.4857 2.58954 -3.33375 20.5696 +7515 6 0.680688 9.01153 7.97148 24.3969 36.1639 -33.0882 +7516 4 54.7452 9.01592 8.14854 -24.8099 -10.5681 8.91807 +7517 4 1.15172 8.32837 8.40327 2.66278 -26.2854 21.5078 +7518 6 42.3319 28.747 39.482 14.4944 54.9029 13.7373 +7519 4 41.6099 28.5069 40.0315 -24.977 -16.9351 14.372 +7520 4 42.5658 28.0062 38.9777 10.1954 -37.5926 -27.6332 +7521 6 38.7351 30.2774 16.2793 4.0737 2.19128 11.2593 +7522 4 38.8758 29.8829 17.1681 -0.562728 7.98522 -10.8415 +7523 4 39.3736 31.0181 16.2214 -9.64538 -12.7452 3.65311 +7524 6 7.59373 18.0328 0.655349 -39.2466 -13.429 1.02247 +7525 4 7.12412 17.545 1.38102 15.2508 10.2608 -15.5396 +7526 4 8.49503 18.0746 0.920891 28.7098 -1.69475 13.4339 +7527 6 33.7283 34.5883 24.1367 2.81913 -0.677006 -1.55035 +7528 4 33.5209 35.3543 23.5868 -0.36085 -2.23271 3.31185 +7529 4 34.0202 34.925 24.9956 3.1898 -0.550642 -1.12415 +7530 6 16.0108 40.0553 39.5926 -11.937 1.54577 -14.812 +7531 4 16.9471 40.1686 39.433 15.7688 -0.191962 4.71606 +7532 4 15.632 40.0274 38.6953 -1.55756 -1.47356 6.94311 +7533 6 4.49381 37.1265 21.8421 33.1234 -31.7004 -39.5319 +7534 4 4.78916 37.7556 22.4729 8.60512 21.3704 21.7375 +7535 4 5.32421 36.8863 21.3047 -36.9575 7.65083 16.8008 +7536 6 39.2568 20.1405 31.3294 -11.3601 -2.01094 -17.3558 +7537 4 39.2441 20.8952 31.9186 1.64276 10.2876 11.6417 +7538 4 38.6708 20.3662 30.5789 5.24327 3.39586 9.04201 +7539 6 28.5615 6.15748 32.0463 -1.77815 -13.6106 -5.56393 +7540 4 29.3688 6.39317 32.5024 4.03477 3.32162 5.90581 +7541 4 28.0645 6.97719 31.936 3.86184 3.53187 3.02469 +7542 6 9.32925 11.326 38.2021 -45.7357 8.82179 -18.9514 +7543 4 8.63026 12.0506 38.2047 26.1946 -20.5574 6.08922 +7544 4 8.95275 10.6938 37.5333 17.8336 11.1262 12.3014 +7545 6 41.6094 10.4714 6.86105 10.1449 -2.02989 30.4141 +7546 4 41.8033 10.1647 7.80154 -6.16714 11.7455 -31.3638 +7547 4 41.7667 11.4361 6.82819 -2.03628 -11.6206 -3.02795 +7548 6 3.11959 28.1093 17.6239 10.7497 -46.175 24.4008 +7549 4 2.68352 28.5892 16.9552 -19.7085 26.1099 -29.6067 +7550 4 3.57016 28.7359 18.1797 1.91623 14.188 4.79643 +7551 6 39.3448 12.237 19.2548 -14.1137 14.4353 18.1644 +7552 4 39.3198 13.2124 19.4672 -0.23776 -25.4214 -5.72266 +7553 4 38.5957 11.8144 19.7397 13.7352 7.639 -10.0067 +7554 6 2.76578 9.12322 31.711 10.2249 -26.7767 20.5709 +7555 4 3.2959 8.42892 32.18 -23.1647 11.967 -1.06293 +7556 4 3.41205 9.47362 31.1162 6.35119 16.2437 -14.7539 +7557 6 47.0978 34.3186 24.1743 26.4285 -20.6373 22.1669 +7558 4 47.9222 34.8155 23.9694 -26.3889 2.76484 -4.38573 +7559 4 46.3048 34.7125 23.8251 -6.69439 19.4391 -11.1209 +7560 6 41.2781 35.6191 9.5379 -9.82526 -0.200667 -5.59214 +7561 4 40.3156 35.6289 9.77314 20.3165 9.2235 -0.933793 +7562 4 41.677 36.5159 9.62264 -17.3348 -12.0484 0.717846 +7563 6 20.4662 31.4486 3.15039 -21.7086 3.64016 -5.07598 +7564 4 21.0332 31.2208 3.90109 -5.23001 0.711793 3.99895 +7565 4 19.5233 31.6154 3.43158 26.7394 -6.53789 -0.258783 +7566 6 33.2215 17.9623 24.8097 -0.453891 -1.34226 7.30289 +7567 4 34.1788 17.9667 25.0617 -18.0356 9.24084 -3.8919 +7568 4 32.8105 18.8566 24.8334 12.2893 -13.6267 3.75162 +7569 6 40.152 39.887 35.7648 -20.6867 7.32712 26.7748 +7570 4 39.5869 39.7633 34.9934 2.3303 1.35559 2.0998 +7571 4 39.5428 40.1203 36.5292 18.9615 -7.74514 -25.9591 +7572 6 4.86846 34.7127 16.4904 2.99496 1.45153 -7.51648 +7573 4 4.94748 35.6438 16.2302 0.473437 -5.16658 -0.520329 +7574 4 5.67201 34.2663 16.1683 2.12015 0.152524 1.06444 +7575 6 19.1332 11.0374 26.5471 0.604362 14.7011 2.3555 +7576 4 19.0986 10.7741 25.6217 -2.73437 -5.06461 -1.05922 +7577 4 19.4813 10.3027 27.0576 -1.53582 -10.5153 -0.687646 +7578 6 54.0201 13.9196 34.7874 -7.69802 -2.07317 -2.05829 +7579 4 53.0764 13.9769 34.9536 -3.33021 -5.1824 4.14914 +7580 4 54.0417 14.262 33.8952 13.8623 5.56658 -9.2157 +7581 6 1.84699 20.6587 5.20972 14.9439 0.361847 -39.2318 +7582 4 1.3018 19.9191 4.88605 -0.816153 4.45331 11.6833 +7583 4 2.38828 20.8916 4.39492 -13.6739 -1.13034 29.3331 +7584 6 22.2428 0.0912174 14.2544 2.10511 -1.36215 24.2926 +7585 4 21.4939 0.626329 14.4934 -11.4394 6.88953 -7.77601 +7586 4 22.6568 41.86 15.1175 2.53583 -3.69112 -10.285 +7587 6 4.95629 7.04242 24.7427 6.31781 -9.23371 -7.19194 +7588 4 4.17782 7.32111 24.2434 0.969413 4.1364 5.47863 +7589 4 5.24611 6.21648 24.3187 1.32276 5.05146 9.71893 +7590 6 41.4805 20.8726 34.9438 -11.2314 22.7349 11.4525 +7591 4 42.1022 20.1554 34.9949 12.4759 -11.6791 0.0999164 +7592 4 41.5325 21.3468 35.8092 3.20944 -13.6901 -15.0483 +7593 6 28.2157 1.74547 31.725 -9.95228 -2.94536 5.02618 +7594 4 27.5723 1.08944 32.0352 4.54694 0.234407 -12.282 +7595 4 28.3302 2.26918 32.5198 6.68924 9.49254 2.75715 +7596 6 16.8899 27.3746 36.9858 -9.49677 -4.03922 3.2671 +7597 4 17.2157 28.1459 36.4964 2.86939 -7.49192 -2.31982 +7598 4 17.0938 26.5386 36.5152 1.89463 15.2676 -1.69393 +7599 6 26.8243 38.069 8.34482 13.7761 41.6132 3.1747 +7600 4 26.4823 38.3279 9.22598 3.84792 -18.6223 -11.4711 +7601 4 26.785 37.1424 8.19579 -7.88027 -37.9853 9.71444 +7602 6 26.6634 33.7911 23.2273 -21.2745 -8.43567 7.74896 +7603 4 27.1019 33.3181 22.5212 7.04537 -0.372104 -6.32159 +7604 4 27.3305 34.169 23.7872 14.5385 6.50935 5.10733 +7605 6 10.2166 27.1183 30.2276 16.2509 -17.1331 -9.46175 +7606 4 10.1765 28.0583 30.3796 2.29392 15.9864 2.71565 +7607 4 10.9387 26.9511 29.5696 -14.5483 8.58048 15.0042 +7608 6 47.87 12.5975 5.02268 -6.13754 10.9902 -1.31963 +7609 4 48.1357 13.4822 5.34438 -4.36861 -17.8106 0.719643 +7610 4 48.2725 11.9144 5.56853 6.38614 1.6905 7.47062 +7611 6 53.3393 24.5639 22.1523 -40.2275 -1.43509 1.91788 +7612 4 53.1884 24.513 23.11 6.12251 -0.709171 0.80005 +7613 4 54.2538 24.6676 21.944 28.1496 2.10984 1.66559 +7614 6 29.4072 10.7569 19.3822 52.4151 15.8336 -9.71081 +7615 4 29.248 9.98119 18.8618 -10.0643 -15.3346 -6.0739 +7616 4 28.6282 10.9567 19.8417 -45.3483 4.87471 22.9978 +7617 6 39.4757 14.9522 19.5461 30.0359 -1.30311 42.0602 +7618 4 40.386 15.231 19.9108 -38.5728 -7.77311 -23.4682 +7619 4 39.3498 15.357 18.6983 1.75067 15.7407 -16.9704 +7620 6 32.8823 15.9838 22.806 -0.988113 9.61369 -4.64335 +7621 4 32.9657 16.5376 23.5815 3.43203 16.8704 5.79609 +7622 4 32.7087 15.1359 23.1895 -5.55033 -22.0541 3.57771 +7623 6 30.5481 1.96835 21.5144 8.4955 -1.31523 7.25762 +7624 4 30.7645 2.06729 22.4547 -1.5525 1.72807 -3.05596 +7625 4 31.3563 1.607 21.1075 -12.3766 3.94884 0.453046 +7626 6 0.972615 11.9937 3.31932 2.75381 16.0475 9.69945 +7627 4 1.12058 12.9582 3.29011 -6.67466 -9.20629 -8.78254 +7628 4 1.16803 11.7633 4.23669 1.49118 -7.35844 2.879 +7629 6 32.1487 30.4035 20.7885 -10.2937 2.79415 -8.64413 +7630 4 32.9584 30.6778 20.3377 1.19491 2.22071 -1.75985 +7631 4 31.4018 30.7106 20.2304 12.8433 -5.61998 7.3235 +7632 6 5.36663 35.5196 9.0005 -13.7636 -10.8617 -1.51226 +7633 4 5.10558 35.6694 8.09522 3.88385 7.21083 -8.97177 +7634 4 4.84313 34.7327 9.21079 3.19207 0.561776 9.20467 +7635 6 49.9075 13.051 32.2032 24.7068 -1.78611 -22.7634 +7636 4 50.5917 12.8604 31.4934 -20.1594 10.2365 23.451 +7637 4 49.3072 12.3042 32.1357 -5.12737 -3.80929 6.93874 +7638 6 4.31321 24.0956 1.58545 -15.4175 -15.0012 -21.2972 +7639 4 3.62325 24.7374 1.73273 -2.73087 12.0747 8.21305 +7640 4 3.96758 23.5799 0.823479 15.3265 9.07188 13.8923 +7641 6 44.1581 38.1227 12.3545 -1.42535 -29.4608 0.820402 +7642 4 43.4877 37.5183 12.7749 7.78878 22.0847 -6.23147 +7643 4 43.9706 39.05 12.5061 -8.83193 8.8938 6.46859 +7644 6 44.688 17.3349 22.7943 52.857 -4.21013 7.29678 +7645 4 45.2391 18.0521 23.242 -20.6522 -19.8992 -14.1432 +7646 4 45.3699 16.6167 22.57 -26.4285 25.231 9.0384 +7647 6 20.3608 11.6914 19.667 7.58964 -15.1508 -20.1027 +7648 4 20.0231 12.466 20.0832 -9.22037 21.7722 17.9466 +7649 4 20.541 12.011 18.7627 0.78957 -9.8802 4.31695 +7650 6 4.45783 15.4051 36.2022 4.17523 -10.6616 -1.13379 +7651 4 5.07913 14.7124 35.8925 -4.22209 9.46347 0.0108161 +7652 4 3.57023 15.0045 36.1544 3.18966 5.51307 1.04981 +7653 6 44.8105 39.5245 30.1712 -12.2097 -12.5983 -29.4865 +7654 4 44.6649 39.2374 29.2388 12.2423 8.81859 19.2473 +7655 4 44.0848 39.0946 30.6384 -0.298867 5.38951 7.86823 +7656 6 30.0635 3.50956 11.3278 16.0802 -2.39158 -40.3094 +7657 4 30.5444 4.30508 11.007 -11.8296 -5.04519 20.5985 +7658 4 30.1379 2.92562 10.5291 -8.6007 1.99314 24.6663 +7659 6 25.6288 24.8657 16.1423 35.3146 -5.68436 -0.158812 +7660 4 26.5897 24.7732 15.9989 -9.69879 -4.30362 -13.2764 +7661 4 25.6615 25.1054 17.0605 -14.6317 7.6504 23.2411 +7662 6 36.8074 29.8609 20.6529 -16.3286 -4.81766 17.6852 +7663 4 35.9316 30.2459 20.3982 14.0867 -8.19012 9.60149 +7664 4 36.7164 29.3161 21.4988 -1.56746 21.2483 -31.978 +7665 6 52.2273 17.0565 38.3075 -18.6216 -30.1938 15.1193 +7666 4 51.4912 16.4635 38.6201 23.7372 14.7716 -7.00173 +7667 4 51.7959 17.5937 37.6524 -0.777677 7.661 -6.77585 +7668 6 3.82637 23.6296 29.8591 26.0466 24.015 14.1033 +7669 4 4.67122 23.3872 29.4436 -4.98409 -4.75234 -2.50433 +7670 4 4.14214 24.3103 30.5173 -20.0237 -17.5461 -14.7603 +7671 6 6.36694 19.9104 41.0994 -7.87156 6.69529 -0.551213 +7672 4 6.75531 19.2216 41.6418 3.91706 -4.8357 7.00798 +7673 4 6.43687 20.7189 41.61 0.371167 5.3541 9.12827 +7674 6 28.9069 38.9219 35.3342 18.1363 5.4885 19.4373 +7675 4 28.4975 38.2544 34.8057 -13.0204 -17.6003 -18.1497 +7676 4 29.7244 38.4883 35.6529 -6.84193 6.3312 -4.3373 +7677 6 1.06391 30.294 34.4744 17.4659 -4.25802 33.126 +7678 4 0.923806 29.8092 33.6831 -4.92213 -16.9626 -31.6436 +7679 4 0.43107 31.0027 34.4841 -13.3738 11.5818 -2.38269 +7680 6 26.4433 22.0338 20.438 10.4135 -19.5508 3.73058 +7681 4 27.3849 22.2767 20.3653 -17.5193 8.20183 -1.91668 +7682 4 25.8117 22.75 20.2981 5.30742 7.62512 -2.77887 +7683 6 3.9439 18.647 22.686 19.6053 -30.212 14.064 +7684 4 4.76982 18.631 23.2404 -22.0254 9.00566 -12.7221 +7685 4 3.71052 19.5535 22.5456 -1.30938 28.7031 -1.82281 +7686 6 6.87955 39.3273 26.9921 -1.67667 -12.9446 -11.9216 +7687 4 7.1836 39.9129 27.6984 -12.429 3.42242 7.34442 +7688 4 5.90054 39.2886 26.9896 13.9064 15.8094 12.8698 +7689 6 43.976 41.7556 26.5281 4.8347 -4.89589 -5.39334 +7690 4 43.9038 0.242071 27.3891 4.48323 5.1383 20.2804 +7691 4 43.1144 41.9148 26.1591 -17.5097 2.26447 -13.804 +7692 6 31.7137 29.57 16.9845 -29.8695 1.84649 5.70955 +7693 4 31.0051 28.8814 16.8861 15.511 13.0746 -1.88966 +7694 4 31.2475 30.3377 17.3963 12.872 -19.7765 -2.8161 +7695 6 46.2467 10.9544 15.5549 14.6537 -15.0388 13.4913 +7696 4 45.2992 10.7621 15.4719 2.35584 -6.3837 2.44855 +7697 4 46.7422 10.1008 15.6673 -18.7057 18.8904 -8.1417 +7698 6 36.5806 15.025 25.8165 21.8026 1.76557 9.13915 +7699 4 37.3648 15.4873 26.2149 -21.7037 -15.0217 -10.3096 +7700 4 36.1201 14.6319 26.5704 -2.31195 -1.95921 2.19148 +7701 6 47.2758 22.6707 6.12549 -20.393 21.5378 -17.5673 +7702 4 46.5536 23.2672 5.80637 16.9751 -15.6011 5.88158 +7703 4 47.0174 22.4855 7.02503 2.56882 -3.04752 8.65489 +7704 6 27.5281 39.6653 17.8063 9.11062 13.5998 -14.667 +7705 4 26.6008 39.6971 17.5421 -9.18871 -3.65478 0.40423 +7706 4 27.5952 39.1072 18.5692 -4.91094 -8.97362 13.813 +7707 6 14.0432 27.9674 36.8911 6.42031 -13.692 3.20322 +7708 4 13.4093 27.2386 36.6831 22.3711 16.0651 -1.21324 +7709 4 14.9745 27.6178 36.9209 -23.5128 3.35359 -2.56993 +7710 6 33.7582 13.0225 13.8549 2.82411 10.3644 -10.1378 +7711 4 34.6192 13.1187 13.3682 -26.1927 -14.0119 11.7219 +7712 4 33.447 12.1034 13.9061 16.5995 3.21583 -3.74575 +7713 6 3.39066 17.4794 1.96807 -11.027 -24.2448 -29.9928 +7714 4 3.01559 16.7425 1.36999 17.4474 35.7284 24.3857 +7715 4 3.43148 18.2603 1.39088 -0.910914 -5.0095 5.82543 +7716 6 27.5636 2.76805 36.4448 23.3016 6.40537 7.49337 +7717 4 28.0874 2.94382 35.6362 -14.0128 -4.70143 5.95918 +7718 4 26.7201 2.39292 36.1778 -1.1877 -0.145823 -5.22631 +7719 6 21.3174 1.20043 18.721 3.60184 -34.5623 26.1973 +7720 4 20.9731 2.06802 18.64 -8.90193 33.3239 -10.7294 +7721 4 20.989 0.903829 19.6038 6.52339 -1.5964 -17.0558 +7722 6 11.8953 16.678 29.2972 -24.0209 -12.1876 15.7906 +7723 4 10.9907 16.5502 28.9196 20.2967 4.53139 4.03679 +7724 4 11.83 16.2797 30.2084 5.50538 14.3948 -24.2902 +7725 6 15.9723 29.4609 29.6333 0.682268 26.1612 18.9471 +7726 4 16.8848 29.3174 29.3467 -1.47573 8.2327 2.84191 +7727 4 15.9822 30.2485 30.2615 3.64459 -27.0302 -18.4378 +7728 6 42.9269 7.03734 4.5197 11.663 -6.03152 6.53833 +7729 4 43.4231 7.50219 3.8104 -1.91258 -11.2042 14.7177 +7730 4 43.564 6.5391 5.10838 -14.9069 13.4822 -19.2581 +7731 6 46.4099 26.3175 18.5001 -14.65 2.77244 -10.2078 +7732 4 46.6739 27.1133 19.0164 -10.4759 -17.1195 -12.5948 +7733 4 45.7242 26.5969 17.8403 16.3643 -1.95791 15.5671 +7734 6 26.8576 31.9381 30.1176 11.4414 -26.9795 -35.8502 +7735 4 27.1259 30.9869 29.8859 -9.79711 36.6724 15.314 +7736 4 26.5998 32.3006 29.2227 5.46388 -10.7605 29.9307 +7737 6 19.4818 37.6192 31.2596 -32.5143 -22.3469 33.0613 +7738 4 19.0962 36.8501 30.8088 8.72557 8.52431 -5.84089 +7739 4 19.0944 37.5229 32.1795 16.9146 13.3756 -22.466 +7740 6 52.3665 32.7318 12.7942 -5.34222 7.33615 -3.08781 +7741 4 51.884 32.8768 11.9489 17.9119 0.95058 7.1847 +7742 4 53.27 33.1068 12.8183 -18.0778 -3.45769 -11.3622 +7743 6 6.73992 9.26339 24.0285 -18.4022 -33.2824 -0.456279 +7744 4 6.43016 9.52976 23.1488 2.39009 0.543925 -1.37305 +7745 4 6.14044 8.50785 24.2751 15.0572 15.2043 -3.93749 +7746 6 39.7373 39.5658 25.499 -11.0807 -5.52867 0.517577 +7747 4 39.7453 38.628 25.2585 2.77876 5.57729 -0.31401 +7748 4 38.826 39.699 25.8216 4.65786 0.889055 -1.26295 +7749 6 24.0734 14.0105 21.1438 13.9648 5.3121 -25.5312 +7750 4 23.6065 13.6215 21.8839 -3.42696 -11.6299 6.48748 +7751 4 24.3304 13.3134 20.491 -9.48085 14.6929 20.6508 +7752 6 5.1987 41.7736 24.8713 10.0047 -19.0707 10.1325 +7753 4 6.05769 0.0475547 25.2635 0.547146 -1.74599 -5.91735 +7754 4 4.86042 0.69526 24.5593 -4.41349 12.4443 -5.8689 +7755 6 42.3687 20.86 21.2777 19.2234 -22.1312 -1.40502 +7756 4 42.3783 20.5581 22.1846 0.624409 -1.73106 8.2154 +7757 4 41.7113 21.532 21.2665 -20.5735 20.428 -5.9858 +7758 6 48.2425 15.3687 33.5924 -0.241089 -2.38933 -5.28694 +7759 4 48.6415 14.7162 33.0072 6.18243 -4.87195 3.86709 +7760 4 47.6596 15.8553 33.0028 -7.11438 7.34599 -0.780278 +7761 6 46.0202 38.2953 16.5865 15.7829 17.4793 7.01852 +7762 4 46.7193 37.7552 17.0318 -13.8218 15.7663 -8.05182 +7763 4 46.1673 39.253 16.8241 -2.73609 -24.364 -6.22008 +7764 6 4.62701 28.4898 21.3631 -35.4199 -38.8764 -1.71187 +7765 4 5.05003 28.7578 22.1614 14.3175 13.903 20.3467 +7766 4 4.23296 27.6059 21.6238 11.0236 23.568 -16.8729 +7767 6 20.5692 15.1618 18.3974 -2.72234 -3.16682 18.7699 +7768 4 20.0205 15.9086 18.1633 -0.374776 9.93651 -8.10169 +7769 4 20.1114 14.8073 19.1799 7.71486 -3.14336 -3.02048 +7770 6 16.2446 13.6415 17.4737 -35.4034 4.06645 -23.9936 +7771 4 16.1835 14.6144 17.5029 6.20848 -12.1 -0.082548 +7772 4 15.5556 13.4035 16.7727 24.4056 2.85778 27.0666 +7773 6 52.5084 30.9566 18.1567 -0.97573 -12.5044 17.346 +7774 4 52.0533 31.4717 17.4985 -6.50351 10.4198 -16.9401 +7775 4 51.7821 30.6074 18.6971 11.4062 2.54252 -4.46582 +7776 6 24.418 1.73203 15.7939 2.07222 -10.1482 7.47229 +7777 4 24.2447 1.14878 16.5739 0.390494 16.7143 -9.44633 +7778 4 24.1366 2.64887 15.952 -0.929678 -6.23215 5.34629 +7779 6 23.8719 5.08832 31.0744 22.7283 -21.9769 -16.2257 +7780 4 23.8146 5.92648 31.5054 -7.3092 22.9653 9.22328 +7781 4 24.8319 4.92382 30.9303 -16.6577 0.531409 1.66203 +7782 6 29.6615 30.9343 0.410524 16.5859 -5.2272 -6.83283 +7783 4 30.4171 30.5602 -0.0763344 -8.98044 0.909776 12.9407 +7784 4 29.1293 31.2514 41.5907 -13.3941 8.54792 -1.14443 +7785 6 32.8591 37.9003 22.5268 -10.9299 -3.56267 -2.34485 +7786 4 33.7082 38.1164 22.1304 5.81458 1.66065 7.83892 +7787 4 32.835 38.1832 23.4516 6.53001 6.08896 0.386172 +7788 6 16.4762 17.3653 33.758 -11.7596 5.685 -6.41316 +7789 4 15.9639 18.0545 33.2621 15.6067 -10.6469 10.7903 +7790 4 17.1589 17.009 33.1621 -6.01342 7.59956 -1.04496 +7791 6 9.22918 13.3839 27.5418 -13.213 -9.30661 16.5651 +7792 4 8.30942 13.5198 27.2923 -4.71042 4.84624 -13.6557 +7793 4 9.0972 13.1179 28.4658 14.0632 -0.809421 3.61995 +7794 6 43.4685 7.73978 17.2176 -8.6426 5.21856 8.44668 +7795 4 43.4054 7.77113 18.1985 3.14312 -1.73226 -22.4674 +7796 4 44.4071 7.82788 17.0033 -0.931382 -0.0897333 1.197 +7797 6 22.3132 24.3412 23.1703 -9.75348 13.1727 -0.0757149 +7798 4 22.7871 23.5122 23.2675 1.8966 -9.89464 -1.11237 +7799 4 21.5045 24.1854 22.6454 4.5924 -1.52242 4.18414 +7800 6 26.0037 32.9236 32.716 -4.33416 -0.788049 -7.61174 +7801 4 26.2455 32.6516 31.8136 -0.0498336 0.850388 -0.133699 +7802 4 25.1949 32.4304 32.9126 -0.360701 -0.787143 2.76329 +7803 6 16.9426 19.041 7.45715 -3.10994 24.472 -2.41526 +7804 4 16.308 19.3093 8.14456 3.13816 -6.91205 -2.30089 +7805 4 17.0114 19.8381 6.87129 1.57938 -24.3813 10.2947 +7806 6 48.1131 14.4569 27.5699 7.08917 8.35207 6.49885 +7807 4 48.0603 15.1245 26.8691 -1.5138 -4.18476 1.16992 +7808 4 48.1537 14.9494 28.4126 -1.96213 -3.76556 -9.73571 +7809 6 52.3834 41.7541 11.1123 -0.447482 12.3 22.2377 +7810 4 52.3153 0.228199 10.2442 -0.817032 7.00513 -16.5207 +7811 4 52.6623 0.571857 11.7011 -4.41087 -5.87968 -8.23494 +7812 6 36.3325 6.93202 12.7048 -8.66608 5.7588 -1.53482 +7813 4 36.3873 7.88419 12.9074 5.41886 -9.49824 0.0534512 +7814 4 37.2464 6.6206 12.6662 3.93968 -0.5832 -0.272047 +7815 6 8.24609 20.3242 16.6676 2.28714 -8.73249 -3.11806 +7816 4 7.99607 19.3797 16.5602 0.915774 9.85224 4.30221 +7817 4 9.21956 20.3717 16.6442 -3.81833 -2.78155 -1.09608 +7818 6 28.8059 40.3215 12.8316 -6.32157 -2.99739 9.80695 +7819 4 29.5356 40.2333 12.2314 15.0973 -2.52646 -11.1155 +7820 4 28.4555 39.4209 12.8947 -4.4969 5.39171 3.74805 +7821 6 18.1648 11.8204 16.9538 6.42365 10.4423 10.6103 +7822 4 17.6537 12.6149 17.1793 -7.21931 -10.1359 -1.31065 +7823 4 19.063 12.1656 16.925 9.05203 -3.86377 -1.18548 +7824 6 30.8803 17.4233 21.4874 -38.9186 -21.5127 -11.6054 +7825 4 30.1793 16.7188 21.4067 15.4039 25.3522 4.50617 +7826 4 31.5864 16.9116 21.8642 20.5617 -1.86838 10.7411 +7827 6 34.8073 19.4112 37.959 10.4013 19.2527 -16.7989 +7828 4 34.9062 20.1671 37.3279 -0.177011 -16.5385 16.965 +7829 4 34.2544 18.768 37.5084 -3.31564 -7.45818 -3.12702 +7830 6 35.8251 16.8879 29.2053 19.9429 8.12055 25.1888 +7831 4 36.604 16.4922 29.6427 -6.21008 5.15879 -2.88988 +7832 4 35.5164 16.1914 28.6524 -12.7517 -21.289 -18.0185 +7833 6 3.03682 32.2806 6.33235 -9.22618 28.6071 10.2197 +7834 4 2.10307 32.1357 6.11945 6.4331 -12.4482 -1.5948 +7835 4 3.56193 31.5065 6.1559 2.8275 -21.5224 -7.32445 +7836 6 26.8 41.6522 10.1614 16.4152 -10.6242 6.62789 +7837 4 27.6763 41.4103 9.75871 -19.2491 6.11251 13.5217 +7838 4 26.9685 0.0827479 11.0562 4.26354 0.263175 -7.76775 +7839 6 52.2755 24.564 24.8743 -17.4742 4.09161 11.4913 +7840 4 51.3068 24.6875 24.9545 12.6777 -6.48001 -7.54331 +7841 4 52.5704 24.9086 25.7267 7.88636 1.59704 3.61539 +7842 6 22.6859 22.6471 33.5865 3.00815 -0.389016 -3.70522 +7843 4 23.2377 23.2516 34.129 -18.2936 -9.34398 -1.8364 +7844 4 21.8798 22.3666 34.0572 9.18357 8.33181 5.74035 +7845 6 10.6559 14.2334 33.0439 8.40108 -6.88321 -2.71679 +7846 4 10.5166 14.9368 32.4181 8.42324 10.9453 -12.1325 +7847 4 9.76709 14.0756 33.3137 -17.8131 -11.8211 11.2552 +7848 6 21.913 10.8504 11.5417 10.0273 5.1408 -10.1307 +7849 4 22.8643 10.6911 11.6864 -4.5907 0.219491 7.97275 +7850 4 21.4519 10.7503 12.3817 3.5408 -3.26695 13.1151 +7851 6 38.3604 6.02409 25.8423 -7.72295 28.2176 13.9057 +7852 4 38.0159 6.28095 26.7202 2.23326 -16.155 -4.56644 +7853 4 38.4362 6.90267 25.4438 5.48615 -7.56939 -11.5178 +7854 6 30.9465 26.6393 38.5732 9.04128 -30.5088 -25.1958 +7855 4 30.9128 26.4505 39.498 -1.67119 3.99535 28.8865 +7856 4 31.0441 25.726 38.2186 -4.36445 16.9712 0.749916 +7857 6 30.1667 14.6301 35.4838 10.1392 5.1159 -4.4805 +7858 4 30.5216 15.3681 34.9096 -25.1579 -14.4294 10.0398 +7859 4 29.1929 14.5877 35.5299 11.6839 11.6021 -8.75286 +7860 6 12.5351 37.2243 16.9695 -17.9994 -5.54058 0.759354 +7861 4 12.9667 37.9067 17.4519 9.84296 27.0859 15.3185 +7862 4 13.2146 36.5653 16.9126 10.1753 -19.489 -6.1469 +7863 6 27.4306 21.5582 37.7184 0.323044 -0.91237 -2.80926 +7864 4 26.8919 21.7087 36.9418 -1.95891 -4.49412 -14.6911 +7865 4 26.9535 22.0297 38.3943 0.198826 4.23191 11.3586 +7866 6 29.6082 18.3788 12.6829 -3.7237 -11.7076 25.6006 +7867 4 29.4829 18.1024 13.618 2.9495 3.49705 -16.1413 +7868 4 28.7034 18.5321 12.3984 -4.77545 3.00323 -3.28229 +7869 6 2.3585 15.6468 0.175999 -8.20612 37.5639 57.3692 +7870 4 1.52386 15.5898 41.6501 -20.1916 -9.73007 -21.8008 +7871 4 3.00191 15.1099 41.6903 28.5072 -35.3577 -30.6151 +7872 6 17.8194 25.7234 4.22068 -18.7286 -4.35761 2.03057 +7873 4 16.8619 25.5897 3.93795 36.6055 5.10926 -2.3659 +7874 4 18.4291 25.8425 3.4621 -13.2431 -0.0346718 7.72723 +7875 6 41.7912 11.1794 20.2704 -4.7703 -4.22644 -3.97484 +7876 4 42.5222 11.2179 19.6258 -6.77094 -1.14571 2.2342 +7877 4 40.9861 11.4636 19.8126 1.73275 2.14556 -1.92771 +7878 6 38.0378 18.3863 24.0278 -3.74133 -10.331 -0.132081 +7879 4 38.4309 19.0888 24.5482 3.22643 8.24914 5.57345 +7880 4 37.9308 18.7305 23.1431 0.767244 4.53126 -6.25669 +7881 6 4.13298 13.9173 33.7521 30.6843 -35.3272 -10.2657 +7882 4 3.2388 13.7394 34.0326 -6.45696 -6.01886 0.999898 +7883 4 4.62487 13.0231 33.6052 -30.6419 39.0128 7.66426 +7884 6 19.1936 19.1847 26.5022 -1.72621 -3.50471 2.07629 +7885 4 19.5259 20.0399 26.2155 5.41694 7.89262 1.74938 +7886 4 18.9505 18.7515 25.6854 -0.500338 -7.01675 -4.74744 +7887 6 22.475 26.1945 25.3345 -21.4458 -23.9003 -3.16659 +7888 4 22.3709 25.4906 24.6814 -7.32491 -4.57374 0.352876 +7889 4 23.3013 26.5414 25.0733 33.537 19.6696 -4.44151 +7890 6 48.8098 32.073 32.5556 -12.1052 4.48194 -0.190297 +7891 4 48.9381 31.1381 32.4233 -5.03309 -16.3747 0.495313 +7892 4 49.6354 32.4434 32.2762 12.9514 12.9364 -2.07298 +7893 6 25.2177 18.014 27.013 4.13139 4.11129 3.02633 +7894 4 24.4991 17.5573 27.49 6.6231 -0.568789 -7.074 +7895 4 25.6482 17.4406 26.3525 -8.92874 -1.57445 7.95973 +7896 6 1.76475 41.5608 24.9549 2.89162 -9.06076 -21.1384 +7897 4 1.88611 40.794 24.3317 -1.07403 19.5272 24.3581 +7898 4 1.30092 0.287142 24.3881 5.67761 -7.93757 11.1942 +7899 6 18.6633 11.7702 10.8608 -14.1102 -15.1967 11.3789 +7900 4 19.5021 11.9001 10.4051 -2.67857 -1.17934 -0.0567829 +7901 4 18.6465 10.841 11.1975 0.382459 20.6246 -9.54243 +7902 6 45.6242 16.5573 4.85031 17.0541 -2.39304 -3.72853 +7903 4 46.5701 16.2411 4.85652 -23.9929 13.0597 -1.64852 +7904 4 45.6057 17.5078 4.58964 5.38323 -15.7737 4.77093 +7905 6 40.6798 36.3894 24.0177 5.99482 15.2006 -18.5281 +7906 4 40.7505 36.8152 23.1136 -3.68852 -16.1642 25.9152 +7907 4 40.7388 35.4259 23.9735 0.360603 0.79119 -4.57544 +7908 6 32.2161 36.322 4.9431 5.19197 18.2152 11.0878 +7909 4 31.5074 36.1415 4.30154 10.9387 -10.0795 -6.57323 +7910 4 33.0257 35.7839 4.88769 -13.0089 -6.05715 -7.93038 +7911 6 1.60369 14.6754 10.8168 -10.3056 7.30247 33.6992 +7912 4 2.33423 15.3134 10.9307 -7.1595 -6.86026 -1.25923 +7913 4 1.1476 14.6845 11.711 13.0511 -0.847163 -26.6328 +7914 6 35.0153 14.2871 28.0739 18.7596 2.69464 30.5166 +7915 4 34.8734 14.0618 29.0187 14.279 3.49385 -12.2543 +7916 4 34.1456 14.1907 27.7398 -26.4062 -1.19123 -20.5956 +7917 6 54.7157 6.11907 21.8609 -12.1949 -7.16094 1.89291 +7918 4 53.7846 6.03827 22.1577 10.7478 1.95047 -3.13077 +7919 4 0.0370646 6.90146 22.3147 2.89466 7.98076 3.79048 +7920 6 31.7642 16.9274 27.3665 -7.54316 -5.52924 6.90942 +7921 4 30.8348 17.1206 27.2023 -9.34166 0.83246 -0.0222557 +7922 4 32.1928 17.2544 26.5838 13.9998 7.82105 -16.2222 +7923 6 14.4504 28.0052 11.1087 -4.71237 -14.6735 4.6077 +7924 4 14.1081 28.8557 11.3451 -9.65694 14.7183 8.34222 +7925 4 14.826 28.1745 10.2406 5.25389 -7.26775 -5.19981 +7926 6 35.6627 19.4906 18.309 1.38743 3.66357 1.00844 +7927 4 36.0608 19.4502 19.1905 -8.3289 1.62604 -1.04031 +7928 4 34.971 18.8114 18.299 7.41978 2.58016 -0.85803 +7929 6 0.908295 12.7232 15.4509 -10.2874 -45.1283 5.64528 +7930 4 0.635795 11.7526 15.3361 10.0925 35.0181 2.47128 +7931 4 1.39513 12.719 16.2997 -3.76012 1.73199 -7.91518 +7932 6 52.7239 14.8052 20.9911 -10.1838 -50.8962 13.8805 +7933 4 52.1355 13.9729 20.9263 20.4043 37.1153 -0.0771148 +7934 4 52.3678 15.481 20.4204 -9.75671 2.85516 -9.21068 +7935 6 7.50014 6.78453 13.6112 45.6118 -3.77462 -0.237279 +7936 4 7.66407 7.72531 13.7166 -11.095 5.64184 -2.33744 +7937 4 8.44113 6.46934 13.5548 -33.3093 -4.56257 -1.46213 +7938 6 12.8693 29.1327 30.951 -35.1999 43.7452 -37.9705 +7939 4 12.911 28.5157 30.2274 6.73286 -14.9776 0.757022 +7940 4 13.2432 28.8129 31.7306 26.8069 -31.1286 39.1504 +7941 6 8.91269 29.9946 35.6682 4.82638 -20.5676 13.9142 +7942 4 9.08199 29.9869 36.6487 -3.4848 12.9743 -23.6701 +7943 4 8.85763 30.8835 35.2999 2.4913 8.97671 5.8399 +7944 6 29.2501 7.21193 5.56384 -35.3124 23.3999 -5.45769 +7945 4 29.8929 6.567 5.7677 24.3163 -25.3556 4.38867 +7946 4 28.4878 7.00912 6.14468 16.2636 8.35776 -7.44031 +7947 6 25.8882 9.2493 3.85609 -10.1418 -10.3657 2.14015 +7948 4 26.6938 8.77544 3.58522 -5.62061 -1.52714 -0.987441 +7949 4 25.143 8.71761 3.5088 14.4855 4.13341 2.07026 +7950 6 46.1828 19.5303 23.8452 27.5142 -8.79556 18.2338 +7951 4 47.0303 19.3932 24.4147 -29.6641 11.3761 -34.952 +7952 4 46.4302 19.9015 22.9687 10.0609 -5.49214 13.8961 +7953 6 18.6 35.3226 28.7813 33.9262 -21.2248 5.29661 +7954 4 18.5078 36.1255 28.2543 2.15121 5.76995 -5.3877 +7955 4 19.5645 35.0126 28.755 -37.0827 17.274 -2.06568 +7956 6 28.0068 22.625 32.1882 17.1638 -9.71048 -11.652 +7957 4 28.1161 23.0799 31.3381 -0.933036 0.686599 6.01892 +7958 4 27.1717 22.9224 32.5558 0.319614 0.839726 2.26602 +7959 6 25.9992 18.4251 22.6716 -8.51512 -6.6596 14.3523 +7960 4 26.8098 18.8237 22.3895 20.3106 6.57833 -11.9809 +7961 4 25.8253 18.8771 23.5162 -1.041 -7.57666 -6.79729 +7962 6 31.1689 23.0872 29.1831 -2.26749 -18.4759 6.78914 +7963 4 31.118 22.1592 28.8841 -5.05583 5.59361 3.05947 +7964 4 31.7418 23.5345 28.5581 5.1573 7.79625 -4.49352 +7965 6 36.6391 4.9259 0.480345 37.9344 10.2065 -26.5572 +7966 4 36.638 5.82198 0.886244 0.658013 -14.6584 -5.92388 +7967 4 37.39 4.95173 41.699 -35.1456 1.42767 30.4358 +7968 6 36.484 21.0145 10.0529 -6.00883 6.48187 8.17175 +7969 4 36.4042 20.1763 9.58301 3.63574 2.58382 -3.15576 +7970 4 35.8773 20.9259 10.8015 2.14778 4.06152 -0.936887 +7971 6 50.5993 25.1947 18.3919 -28.2028 12.9956 8.35013 +7972 4 49.869 24.7394 17.9262 9.19638 1.46827 3.55355 +7973 4 51.4482 24.8993 18.0848 11.0575 -8.08323 -5.33222 +7974 6 50.1824 39.6576 12.4356 -22.7811 -7.9912 15.1349 +7975 4 49.7705 38.7879 12.6194 4.75387 11.043 -2.88475 +7976 4 51.0686 39.4751 12.1603 15.8621 -1.53988 -6.37666 +7977 6 30.5412 12.4178 4.80566 -15.3128 -2.78075 25.3711 +7978 4 30.0752 11.5776 5.01806 10.6669 11.6172 -5.90727 +7979 4 31.021 12.2424 4.01172 11.531 -8.83371 -18.4272 +7980 6 28.9525 15.4713 21.8679 -2.36978 -36.4192 26.6063 +7981 4 29.1677 14.6271 22.3934 -7.66269 33.2693 -19.6276 +7982 4 28.1632 15.8063 22.3348 7.54721 -2.84859 -11.2752 +7983 6 14.0684 9.5583 16.997 2.7235 -6.59901 -0.744295 +7984 4 14.8185 8.94582 17.0717 -0.0957791 5.7783 -3.11218 +7985 4 14.4323 10.4488 16.9992 1.00571 2.57913 -1.39277 +7986 6 4.48903 30.1743 11.858 18.777 -10.7052 13.2768 +7987 4 4.86699 29.7697 12.6847 -17.3276 7.96894 -17.1216 +7988 4 3.53137 30.2861 11.9207 -0.113543 -0.314347 4.01346 +7989 6 40.8874 8.0652 23.6541 0.993335 -18.0149 -24.6412 +7990 4 41.0014 8.23968 22.6934 -0.45004 7.6784 15.1082 +7991 4 40.7726 7.0925 23.6399 1.20374 9.92563 8.58777 +7992 6 53.7462 35.0557 16.7061 9.98011 -4.48961 -22.2856 +7993 4 53.4827 35.8182 17.2307 0.000554802 6.10184 -1.96461 +7994 4 54.0786 35.3449 15.8213 -7.68991 -0.599931 23.4559 +7995 6 53.7073 10.1889 20.3718 -10.7517 16.2467 -19.4493 +7996 4 53.8408 10.0262 19.4272 8.41512 -10.415 5.03553 +7997 4 53.1338 10.9644 20.2967 0.731263 1.06205 11.7435 +7998 6 4.58979 27.075 7.78807 17.6653 -15.6715 -1.75621 +7999 4 5.19096 26.32 7.80399 16.3727 7.79792 -3.24405 +8000 4 3.78382 26.6199 7.94519 -28.415 1.42755 3.38346 +8001 6 50.5066 22.5306 22.1436 -1.2339 18.6921 5.41009 +8002 4 50.2802 23.3104 22.6632 -2.8343 -11.09 7.6214 +8003 4 50.7991 22.9414 21.3369 4.56213 -7.53044 -15.8119 +8004 6 7.04346 27.196 21.628 9.41144 -9.96736 11.8657 +8005 4 6.8407 26.6883 22.4668 -8.25713 16.2835 -27.3312 +8006 4 6.26031 27.4748 21.116 4.26862 -9.43237 15.0117 +8007 6 23.8265 35.0499 16.5937 18.3012 9.13896 26.4348 +8008 4 24.7235 34.8381 16.9269 -14.9485 7.62278 -2.13189 +8009 4 23.7604 34.5968 15.7714 -3.77201 -11.7597 -22.7393 +8010 6 5.98953 23.8983 3.91761 -44.4181 -14.5448 -1.98234 +8011 4 5.398 23.9519 3.1318 15.794 0.401012 8.45254 +8012 4 5.35617 23.6012 4.61938 19.6174 4.72778 -5.04958 +8013 6 38.7401 25.0729 19.1247 8.8169 4.91643 10.7802 +8014 4 38.7862 24.2921 18.5681 -1.99613 -8.272 -9.94687 +8015 4 39.0639 24.8191 20.0061 -2.94522 4.87881 -4.09917 +8016 6 12.9717 18.2893 10.6182 7.92512 -8.05782 -7.58833 +8017 4 12.0999 18.3162 10.2013 -2.76008 2.25331 1.21984 +8018 4 12.8722 18.6085 11.5165 -3.68712 5.29275 10.5515 +8019 6 38.0382 41.2423 21.0873 4.88219 -19.6272 -0.152698 +8020 4 37.2014 40.7765 21.2484 2.63704 8.02432 -2.02816 +8021 4 37.8835 0.198079 20.7163 -11.2369 15.8096 -5.69312 +8022 6 6.98214 22.8682 17.8394 -5.75247 -17.9204 -1.57462 +8023 4 7.61723 23.542 17.6412 15.6839 20.0065 -5.16874 +8024 4 7.3587 22.0484 17.4826 -2.13646 0.815835 3.23256 +8025 6 24.1186 19.368 12.3177 21.0449 6.23804 -24.2445 +8026 4 23.9242 19.844 13.1293 -4.19124 -3.15082 3.8784 +8027 4 23.743 18.4928 12.3308 -10.9397 -14.908 7.07664 +8028 6 44.2213 28.4415 4.8153 2.12167 -7.44997 -5.8313 +8029 4 44.3009 28.0649 3.91739 -1.37383 9.18016 5.99771 +8030 4 44.2294 29.4128 4.74855 1.01191 -3.53144 -7.03239 +8031 6 23.3167 8.29314 21.4338 -0.329791 14.7993 14.6131 +8032 4 22.995 9.23581 21.5362 7.25813 -26.2111 -7.67418 +8033 4 23.1349 8.01865 20.5229 -2.36131 4.58949 1.23489 +8034 6 14.3464 2.19127 18.5365 1.00479 -5.05512 -1.33996 +8035 4 14.3534 1.26337 18.7781 -10.0191 -8.45544 9.17935 +8036 4 15.2531 2.29149 18.2562 13.6881 11.5937 -7.27189 +8037 6 28.0536 31.92 34.134 3.57463 -14.0429 -1.6048 +8038 4 28.4517 32.4188 34.8607 -2.66641 5.35559 -0.0232853 +8039 4 27.3246 32.4577 33.7701 8.655 -3.68096 2.2403 +8040 6 53.3502 24.7032 18.2649 -24.2711 -41.2818 -9.83264 +8041 4 53.5194 24.6019 17.3193 6.96991 8.47211 -0.102973 +8042 4 53.68 25.5059 18.6169 17.7955 37.5084 3.34479 +8043 6 36.8031 28.4187 22.9511 -10.1554 -0.61119 21.2214 +8044 4 36.5106 28.9054 23.7358 4.15696 8.73481 -5.19311 +8045 4 36.1845 27.6911 23.0035 -2.36033 -17.8474 -9.79811 +8046 6 21.8885 30.5877 27.4793 -3.11585 8.28062 7.57241 +8047 4 22.2621 31.0993 28.2061 -3.96796 1.5816 4.48491 +8048 4 22.5937 30.5949 26.8475 10.2249 -8.24374 -18.6607 +8049 6 10.2833 3.28406 27.2289 -24.5304 -2.91212 14.6365 +8050 4 10.0443 2.76427 28.0065 14.6588 -5.9106 -2.57837 +8051 4 9.44832 3.75002 27.1066 2.80489 10.142 -13.305 +8052 6 37.7147 24.9939 29.6988 5.24245 -12.5023 -10.1121 +8053 4 38.3581 24.5533 29.0689 -23.3017 1.4918 23.5498 +8054 4 37.1779 24.3214 30.1874 12.7329 5.56421 -12.5271 +8055 6 9.13611 24.4367 14.4784 20.7258 8.96054 28.4908 +8056 4 9.04651 24.998 13.735 -5.03994 20.1658 -22.0876 +8057 4 8.726 23.6299 14.2398 -14.2121 -32.2206 -7.12291 +8058 6 52.7755 31.4643 7.39569 14.5412 -1.52098 0.484013 +8059 4 52.3413 32.1584 6.88884 0.00633314 4.2069 -4.47258 +8060 4 52.0605 30.9716 7.79316 -9.34275 -9.05133 5.36325 +8061 6 21.3287 5.44475 36.4975 17.176 -11.9485 -14.2877 +8062 4 20.7483 5.50715 37.2619 4.90115 -8.53405 7.77147 +8063 4 21.912 4.64524 36.5597 -18.1029 20.6035 4.94996 +8064 6 25.1768 37.2214 4.32574 4.31983 -25.8241 -7.35849 +8065 4 25.4326 36.64 3.57657 -1.88178 18.0132 5.09494 +8066 4 24.8685 36.5657 4.9694 -1.32139 10.7309 7.78615 +8067 6 33.9928 17.4475 18.2473 -28.4515 -0.0793518 28.5349 +8068 4 34.2921 17.0113 19.1053 -15.0281 13.9289 -20.2703 +8069 4 33.1064 17.9171 18.4165 33.1367 -21.5966 1.81969 +8070 6 37.9532 37.4932 25.2939 -37.7872 -15.4269 -20.4394 +8071 4 36.979 37.7096 25.1406 34.3292 -3.43428 9.43604 +8072 4 38.1084 36.7677 24.6487 1.47089 11.2608 10.0337 +8073 6 5.08061 4.87523 15.8431 -4.86231 -7.56388 -2.23136 +8074 4 5.78156 4.1744 15.8759 -9.54967 26.0091 2.46095 +8075 4 5.43258 5.75 16.0822 6.78608 -13.538 3.56789 +8076 6 14.1628 7.20449 7.78038 25.2379 -5.46067 -13.6381 +8077 4 13.5115 7.54153 8.36471 -22.6877 11.2017 23.85 +8078 4 13.6914 6.99143 6.96374 5.13235 0.836748 0.117842 +8079 6 24.9714 10.8522 38.0874 21.7543 24.8019 24.8971 +8080 4 25.3733 11.7327 37.9223 -2.75098 -14.513 10.3213 +8081 4 24.5811 10.6456 37.27 -22.0988 -18.3607 -37.1034 +8082 6 35.6792 7.98105 22.8098 -5.63995 -0.874411 -1.68631 +8083 4 36.3111 8.66137 23.0699 5.30437 2.23481 0.770305 +8084 4 35.3824 8.20038 21.9134 0.62108 2.61089 2.3422 +8085 6 24.7967 29.145 22.4166 8.97915 1.26062 2.6062 +8086 4 24.9285 28.4017 23.0307 -7.24415 3.31799 -2.87627 +8087 4 23.8684 29.1691 22.1667 -6.93063 -5.53381 0.128782 +8088 6 38.5003 31.6402 38.4666 0.118802 17.9484 -3.06973 +8089 4 38.5639 32.3894 37.8454 -0.598215 -11.959 -0.514206 +8090 4 38.3632 32.08 39.3134 -2.43734 -3.45212 12.1107 +8091 6 7.2246 33.2558 15.4144 3.93224 14.6297 14.7993 +8092 4 8.10558 33.3578 15.8508 -19.4169 -6.69939 -13.0108 +8093 4 7.30076 32.5035 14.7978 2.24681 10.3389 8.67702 +8094 6 43.3411 23.605 1.45378 1.24542 -6.52262 6.11498 +8095 4 43.1714 24.3501 0.858367 5.1295 -5.17404 3.37123 +8096 4 44.2208 23.7695 1.84296 -12.8059 2.13297 -8.4534 +8097 6 3.53981 32.9157 14.8686 -7.67856 -8.73615 6.98201 +8098 4 3.60397 33.2061 13.9566 0.668747 6.43783 -7.96574 +8099 4 3.81902 33.649 15.4236 5.03764 7.23473 -0.501009 +8100 6 25.308 21.7722 8.24708 3.37146 -12.406 14.7751 +8101 4 26.0573 21.1741 8.36562 1.41198 8.84323 -6.65363 +8102 4 24.826 21.6647 9.09095 -1.64121 7.89428 -12.8382 +8103 6 43.814 15.3562 17.763 -19.8802 -3.64728 -7.58039 +8104 4 43.4756 15.1225 16.8733 5.20247 0.973102 4.81929 +8105 4 44.7686 15.2775 17.7045 7.07231 -2.77487 -5.74422 +8106 6 15.7867 16.2594 16.6597 40.7179 11.0003 30.8626 +8107 4 16.4245 16.8568 16.2414 -0.344326 0.180624 1.74019 +8108 4 15.1074 16.2177 16.037 -41.8412 -2.72902 -33.087 +8109 6 31.9018 12.864 11.5221 -0.527288 11.9796 -2.61342 +8110 4 32.4715 13.19 12.2739 -15.261 0.218931 -18.2329 +8111 4 31.4408 13.5947 11.0331 13.5047 -10.6099 18.0399 +8112 6 18.2179 5.3463 10.1762 9.71532 5.2148 -18.3501 +8113 4 17.8204 5.66693 9.33813 -2.6575 -7.74782 15.1878 +8114 4 17.5556 5.18411 10.851 -9.29453 0.73034 -3.17809 +8115 6 23.0812 39.0781 10.9303 2.37609 8.25457 -4.90642 +8116 4 24.0025 38.8104 10.892 -1.10831 -0.594451 2.83356 +8117 4 23.078 39.9337 10.4697 -7.78026 -4.85412 5.47405 +8118 6 46.8678 33.747 8.76655 -5.11485 44.7451 24.4631 +8119 4 46.406 34.5339 8.40734 -0.304999 -21.98 -10.152 +8120 4 47.1603 34.1422 9.62028 2.09293 -20.2864 -11.5212 +8121 6 31.2447 39.9321 20.2226 -0.330123 -0.585472 -4.98228 +8122 4 30.8504 39.3151 19.5884 6.05804 4.05585 3.92388 +8123 4 32.2053 39.9316 20.0453 -4.95864 -1.44581 -1.12159 +8124 6 15.9016 33.0949 19.7876 25.1907 -5.52815 -22.1207 +8125 4 16.0748 33.7133 19.0349 -1.92202 -14.988 11.1016 +8126 4 16.5267 32.3265 19.6592 -15.8695 19.8556 5.2806 +8127 6 32.5654 39.9188 2.66304 17.6014 -10.2623 -15.3377 +8128 4 33.3417 39.59 3.14903 -11.9816 5.68487 0.865723 +8129 4 31.9971 40.348 3.29791 -5.42947 4.08066 9.69521 +8130 6 50.71 12.2088 3.91621 6.45352 -28.1924 -19.9843 +8131 4 51.4315 12.4725 3.33505 0.00989865 5.72461 1.55844 +8132 4 50.5782 12.8645 4.57223 -0.528152 29.464 22.8196 +8133 6 44.6954 2.75762 12.1022 0.941183 0.541095 5.21442 +8134 4 45.0772 1.91827 11.8337 7.97486 -4.13832 -5.1586 +8135 4 44.7961 2.76556 13.0748 -3.12194 1.26681 -13.8655 +8136 6 11.5119 11.9446 31.6555 0.0165034 5.87533 16.9496 +8137 4 11.2786 12.7291 32.193 1.1093 -4.42098 -1.85793 +8138 4 11.5615 11.2089 32.2952 3.49417 6.36211 -10.0029 +8139 6 4.75553 10.0442 10.5026 -0.613356 7.28818 -1.41717 +8140 4 5.04922 10.2458 11.3982 -0.190174 3.033 -2.19553 +8141 4 4.45357 10.8768 10.0827 4.22944 -8.29703 6.91569 +8142 6 17.1004 25.0221 20.585 20.8628 27.7333 -27.8469 +8143 4 16.2314 24.7196 20.7848 -24.892 -11.5638 6.73224 +8144 4 16.9745 25.5771 19.7683 4.93088 -15.3222 19.1034 +8145 6 48.1032 4.75801 14.8026 37.7024 -16.8658 7.41777 +8146 4 47.1817 4.923 14.9438 -21.3904 13.2232 -6.86149 +8147 4 48.4894 5.33532 14.1187 -17.354 1.23192 4.40994 +8148 6 18.8584 3.1094 3.41532 -17.9645 -5.092 -5.76247 +8149 4 18.4858 2.24853 3.65522 2.22195 0.198645 3.24183 +8150 4 19.7914 2.99202 3.55078 21.8001 -2.9136 1.99579 +8151 6 35.4214 26.4496 29.0479 -25.0869 -13.2406 8.30382 +8152 4 35.4596 27.2122 28.4766 3.66886 10.9927 -9.48044 +8153 4 36.2884 26.0622 29.0901 17.6032 -4.12101 -3.28535 +8154 6 32.3918 31.2203 12.8386 46.3164 14.9485 -1.56764 +8155 4 31.5927 31.2548 13.3118 -34.7781 -0.694705 18.2501 +8156 4 32.2274 30.836 11.9945 -8.46486 -12.2685 -25.2096 +8157 6 32.9972 28.3347 37.5978 -19.2694 -14.478 20.0019 +8158 4 32.1604 27.8545 37.87 25.9433 12.8245 -4.2723 +8159 4 33.4478 28.5699 38.4425 -10.0504 -3.89776 -17.7975 +8160 6 45.4943 24.785 10.3174 -24.9891 51.3938 13.5053 +8161 4 44.9436 25.3819 9.72852 18.6998 -28.2383 15.0369 +8162 4 45.6946 23.9769 9.88803 3.95472 -26.3164 -24.236 +8163 6 14.7646 31.7016 3.17106 -12.494 -4.77828 16.8956 +8164 4 14.1278 32.382 2.84257 8.55448 -13.727 9.9815 +8165 4 14.4774 31.2925 4.03575 0.781246 20.1514 -26.73 +8166 6 31.932 7.70259 4.29822 28.2629 -13.9597 32.9447 +8167 4 31.5142 6.8338 4.23667 -1.26054 0.464616 -4.26218 +8168 4 31.5893 8.26695 3.64018 -18.9284 22.0156 -31.588 +8169 6 42.5661 17.3076 32.2072 4.58091 20.9841 -12.8778 +8170 4 41.6153 17.2751 32.1225 -13.9289 -9.63208 0.974916 +8171 4 42.7549 18.1312 31.7017 7.23855 -15.1499 9.29454 +8172 6 13.801 23.1802 23.5544 20.5107 -9.18639 9.43365 +8173 4 13.5559 23.799 24.2431 -7.02941 8.57916 4.58982 +8174 4 14.6139 22.757 23.9348 -15.8084 7.21572 -12.2969 +8175 6 10.7224 7.09218 3.96878 16.2046 -14.1912 -58.7694 +8176 4 10.4615 7.01435 4.86228 -13.7845 -9.22242 34.898 +8177 4 10.4899 6.25858 3.45399 4.94204 24.1379 24.5516 +8178 6 28.7975 8.66057 17.8838 -26.4281 5.00156 -27.4828 +8179 4 29.5466 8.31163 17.3909 5.91048 -3.96826 -5.96201 +8180 4 28.1517 8.96764 17.1731 20.0585 -9.38402 22.2692 +8181 6 19.4445 29.3512 26.6402 -27.7559 12.8002 37.2849 +8182 4 18.9931 29.7086 27.4672 16.1765 -10.1498 -30.4371 +8183 4 20.3292 29.7071 26.6996 8.86807 3.45557 2.67965 +8184 6 40.676 40.9989 14.5783 -1.81287 -10.2023 17.4849 +8185 4 40.8703 41.6798 13.9303 10.8761 5.87921 -5.34291 +8186 4 41.4788 40.6754 15.0317 -0.103076 9.61372 -9.63617 +8187 6 46.2568 14.0853 31.7234 10.6503 -1.46249 4.93376 +8188 4 46.4506 13.1375 31.7184 -3.79774 3.42444 -0.601084 +8189 4 45.5065 14.2191 31.1522 -8.96365 0.976246 -7.34606 +8190 6 36.7103 36.3065 8.39844 -19.1971 -27.2559 -17.1971 +8191 4 36.3822 37.2167 8.51449 20.2374 -9.10083 14.9839 +8192 4 37.462 36.0245 8.9597 -8.83948 23.9771 2.75809 +8193 6 30.7983 32.4219 38.0908 -28.9564 1.76229 18.7871 +8194 4 31.3387 31.9445 37.476 23.2205 -2.83162 -11.1976 +8195 4 31.2894 33.1287 38.5298 9.85106 -3.61838 -6.87003 +8196 6 47.9 8.84746 10.1809 13.9026 13.2481 4.99334 +8197 4 47.2314 9.07534 9.54683 -14.9306 19.0332 -8.73943 +8198 4 48.008 7.93273 10.003 10.2061 -26.7512 4.08493 +8199 6 24.4282 17.0027 30.9766 -8.14946 0.47403 -13.61 +8200 4 23.7021 16.9118 30.3187 14.132 0.581257 9.28124 +8201 4 24.0019 17.1514 31.8341 1.66288 -1.35228 -5.87998 +8202 6 40.5039 5.09263 4.48513 -8.56504 -6.5373 -32.2613 +8203 4 41.2755 5.64065 4.37578 16.2932 9.35997 9.97847 +8204 4 40.1843 5.0523 3.55179 -2.89742 -7.45623 19.6864 +8205 6 52.5794 28.086 6.91602 -27.2154 -20.1235 6.97783 +8206 4 52.4353 28.6007 6.11552 3.94928 -0.112987 0.705634 +8207 4 51.6969 27.6552 7.08025 27.1089 14.7333 -4.60736 +8208 6 36.0629 32.381 23.6142 9.17579 -16.9148 -2.4755 +8209 4 36.5407 32.2813 22.7776 -1.15674 3.38979 7.41153 +8210 4 35.7113 33.2654 23.6252 -9.15386 11.2493 0.0331211 +8211 6 23.6552 31.8756 22.7565 -25.0136 1.00336 21.6204 +8212 4 23.73 32.5959 22.1297 15.1034 -2.64982 -11.1407 +8213 4 24.3343 31.2055 22.6866 12.2933 -0.39941 -10.0267 +8214 6 0.736598 24.4641 41.7072 -6.94393 1.55048 -19.4095 +8215 4 1.23654 24.8288 40.9522 -3.95743 -2.80997 9.51773 +8216 4 54.8325 24.2702 41.3637 13.4109 4.08216 3.5339 +8217 6 15.9721 8.97822 19.8125 19.0517 -22.613 16.6544 +8218 4 15.5497 8.29105 19.3091 -4.28185 -9.24838 -10.3339 +8219 4 15.6128 9.78815 19.5092 -16.7051 35.4763 -13.493 +8220 6 33.1656 12.5735 20.0353 32.8597 -32.3881 -24.7893 +8221 4 32.9817 11.6196 19.8453 -6.04217 28.6875 8.28399 +8222 4 34.1172 12.6638 19.7368 -32.1809 10.6792 11.3696 +8223 6 7.04894 24.9401 26.3957 -12.3425 -2.00741 -5.21086 +8224 4 6.75821 24.2907 27.0478 8.01299 -1.99342 6.24335 +8225 4 7.89161 25.3154 26.6505 10.7219 -3.29246 12.7441 +8226 6 44.479 22.5508 36.9163 -6.8399 -5.44184 13.3083 +8227 4 43.5214 22.4098 37.071 12.5044 3.3732 -3.51472 +8228 4 44.595 22.7899 36.0028 -4.86816 3.42784 -13.6235 +8229 6 39.2745 23.7032 25.1197 -32.3737 -81.7274 9.17932 +8230 4 39.5886 24.5492 24.9992 24.471 68.8814 -13.2187 +8231 4 38.7456 23.4691 24.3377 5.22396 6.33701 6.85867 +8232 6 20.3646 2.19602 36.9892 -4.85825 6.83938 3.69158 +8233 4 20.3067 1.45038 37.5971 1.4243 -8.23943 -2.36696 +8234 4 20.3942 1.88275 36.0861 3.42557 -6.35335 -2.19064 +8235 6 22.8664 19.5513 3.67104 -13.2265 5.28042 31.2857 +8236 4 22.7633 19.8561 4.6286 7.01101 -9.22167 -32.7463 +8237 4 23.7764 19.7315 3.39612 4.00916 2.85623 5.02623 +8238 6 31.705 12.5768 34.6039 18.8969 7.7197 42.0834 +8239 4 31.1026 13.3107 34.9476 21.2302 -23.3848 -5.30166 +8240 4 32.3569 12.3026 35.3493 -33.8624 17.1964 -33.567 +8241 6 12.9851 10.2105 25.0956 -25.1193 26.0078 -38.429 +8242 4 13.6149 10.0452 25.7619 22.39 -15.9831 32.7066 +8243 4 12.4963 9.40655 24.9468 1.34194 -14.9569 1.62555 +8244 6 27.2621 0.584423 13.2176 -28.6404 -16.2485 2.71576 +8245 4 27.7069 41.6292 13.1518 2.13728 8.59646 -2.51953 +8246 4 26.2847 0.395264 13.1771 23.0038 6.72582 -0.601928 +8247 6 5.66006 24.9398 13.9833 -7.43295 9.91556 10.5591 +8248 4 4.70147 24.9177 13.9802 -4.26929 -7.73667 -8.07402 +8249 4 5.82197 25.381 14.8221 8.41297 -1.15026 -0.763214 +8250 6 22.9908 17.9523 0.521723 7.02411 -25.4698 12.909 +8251 4 22.4592 18.6506 0.142784 -9.22706 3.46645 -2.83539 +8252 4 22.3527 17.3052 0.930771 13.2695 22.3169 -13.3733 +8253 6 33.0935 25.4243 5.46557 -9.38497 -10.8046 -8.60877 +8254 4 33.4966 26.2756 5.44764 14.9521 17.8538 5.01915 +8255 4 32.9941 25.2035 4.5344 -2.6207 -6.96629 2.5324 +8256 6 8.53079 7.95552 17.4804 7.64086 6.41223 -26.4035 +8257 4 9.4001 8.35547 17.2638 -9.73917 -4.33322 7.64386 +8258 4 8.4487 7.94255 18.4286 4.30191 2.70426 16.6029 +8259 6 26.8371 0.685906 2.89773 -0.256761 31.01 4.86999 +8260 4 26.7806 0.433187 3.83156 0.637082 -2.67537 2.60738 +8261 4 26.6279 1.66343 2.89109 6.9325 -26.481 -2.08778 +8262 6 50.0417 34.7142 15.6334 -23.0288 8.72534 -30.9996 +8263 4 50.5531 35.2159 14.9759 6.02412 -4.51102 12.1494 +8264 4 49.1615 34.6714 15.1751 14.0914 -5.62478 19.352 +8265 6 46.2791 4.99946 11.1196 9.7179 12.4772 -7.72995 +8266 4 45.7827 4.25534 11.4529 -10.6417 -11.5364 6.26713 +8267 4 46.9456 4.6214 10.5389 1.00953 -4.68959 -1.2994 +8268 6 33.7936 38.6123 35.3918 15.2762 25.882 47.4359 +8269 4 34.0305 39.0866 36.2411 -6.18084 -28.1229 -24.2145 +8270 4 33.6134 39.3784 34.8506 -5.42867 -1.33428 -20.4371 +8271 6 30.8282 25.8371 41.2172 -7.09757 -19.9215 -22.3179 +8272 4 31.1427 24.9253 41.375 1.19635 8.28989 4.89631 +8273 4 31.1138 26.3841 0.0263053 10.2845 10.2166 22.0109 +8274 6 50.2275 0.982033 24.4751 51.8832 -7.79127 14.7425 +8275 4 49.5671 0.561213 23.9746 -37.5145 -10.5742 -20.1648 +8276 4 51.0349 0.46072 24.2534 -17.6876 18.8276 11.0022 +8277 6 31.2908 0.710797 19.047 -2.09434 13.573 -1.22083 +8278 4 30.4487 0.672221 18.611 -14.5784 9.11804 -11.7691 +8279 4 31.2841 41.7946 19.4765 8.98672 -35.4229 20.9418 +8280 6 39.0741 29.5515 19.1276 -25.3595 -21.9961 15.137 +8281 4 38.1807 29.4949 19.565 25.109 7.94863 -12.7917 +8282 4 39.4837 28.6866 19.3452 2.49072 15.8212 -6.56848 +8283 6 21.6546 17.5955 25.8962 -6.78298 15.7545 0.118362 +8284 4 22.0482 18.4938 26.0891 -15.3421 -24.4294 -5.96834 +8285 4 20.8112 17.7106 25.4012 18.8301 2.25602 6.45745 +8286 6 35.0761 28.7988 27.4227 3.11164 -5.22767 30.3338 +8287 4 35.4099 29.4705 28.0422 -1.31539 -7.25274 0.820077 +8288 4 35.176 29.229 26.5925 2.58985 10.308 -31.8228 +8289 6 30.7102 25.4463 11.6589 -5.09223 14.513 32.8165 +8290 4 30.6059 25.8179 12.6014 3.72506 -14.6402 -39.0718 +8291 4 30.6061 26.1982 11.055 2.14208 -0.820709 7.44645 +8292 6 7.34821 15.124 12.3469 -7.98455 -28.7648 8.02815 +8293 4 6.65824 14.4547 12.1585 7.38491 7.52419 4.72727 +8294 4 7.19665 15.7511 11.658 -2.78105 24.4343 -15.0907 +8295 6 16.8417 26.815 7.05419 -24.774 6.28148 -21.5195 +8296 4 17.6138 26.5995 7.5418 30.7131 -10.23 16.3776 +8297 4 17.1302 26.9688 6.14022 -2.93816 -3.28182 4.8763 +8298 6 29.5112 33.0571 30.9901 -17.2684 21.8413 -16.809 +8299 4 28.6007 32.8494 30.6893 8.91061 -10.9491 6.08618 +8300 4 29.8939 32.355 31.5124 -6.62171 -19.0922 5.25725 +8301 6 14.1054 2.12143 30.9174 -7.90077 -11.4283 37.211 +8302 4 14.0041 2.00138 31.9209 0.0297695 4.78336 -39.0496 +8303 4 13.7376 1.30679 30.5176 6.48361 9.45743 4.44265 +8304 6 15.6593 22.2688 2.88796 -26.3773 12.8308 -8.6958 +8305 4 16.4059 21.7286 3.01985 35.1738 -16.1657 6.55343 +8306 4 15.0005 21.6175 2.62854 -10.183 2.33344 0.69621 +8307 6 23.7324 29.1178 40.9691 12.375 28.71 1.88761 +8308 4 23.2563 30.0016 40.9795 15.1309 -27.3218 0.73938 +8309 4 24.7153 29.2815 40.9372 -24.8849 -3.40565 0.339466 +8310 6 38.1289 14.1609 13.7163 11.3988 23.3452 4.961 +8311 4 37.6355 13.3641 13.8052 -15.0683 -25.2976 3.04519 +8312 4 38.877 13.9408 13.1592 7.07353 -0.711776 -7.39216 +8313 6 35.2564 26.5047 15.5196 1.21661 4.3606 12.6683 +8314 4 34.5556 26.4436 14.8616 -0.145442 -0.409522 -0.299569 +8315 4 34.9009 27.0522 16.256 4.1263 -8.75979 -17.8666 +8316 6 19.0944 34.7315 16.477 3.93496 0.874554 38.8769 +8317 4 19.5342 35.6013 16.5498 -2.87948 -9.96323 -9.99674 +8318 4 19.0181 34.4301 15.5899 3.71142 3.01681 -30.4069 +8319 6 18.1805 29.7449 35.7046 18.8444 17.1873 -3.97052 +8320 4 18.2235 30.6593 35.335 -4.4784 -20.2666 13.1463 +8321 4 19.056 29.5886 36.1261 -9.76671 1.23141 -6.47371 +8322 6 54.1188 22.2659 24.9096 4.78421 -24.6774 -19.3149 +8323 4 53.6441 21.8104 24.1769 10.121 5.11789 9.9801 +8324 4 53.5075 22.9378 25.1661 -14.3198 20.1313 5.7187 +8325 6 30.3323 10.3375 34.0061 7.35563 0.641124 -2.21855 +8326 4 29.5734 10.4043 34.5817 -14.4555 0.0376959 9.72957 +8327 4 30.8213 11.1653 34.1487 -3.17747 -4.67635 -0.590304 +8328 6 38.3211 33.8974 18.5888 -1.32754 -0.89807 -0.720993 +8329 4 38.9926 33.271 18.8539 2.22312 -19.1913 3.89796 +8330 4 38.8713 34.6655 18.5317 3.84957 24.8056 -1.31283 +8331 6 22.4809 14.1697 34.431 -22.1622 -5.27184 -37.8541 +8332 4 22.5433 13.5186 33.673 0.822047 20.8222 24.5167 +8333 4 23.1773 14.0067 35.0533 16.0768 -5.18569 10.3575 +8334 6 38.0141 0.622036 2.34694 9.03481 -5.1652 10.3599 +8335 4 37.7113 1.09641 3.1189 -18.3016 16.1314 2.00329 +8336 4 38.7028 0.120019 2.79986 6.1006 -11.8827 -16.4842 +8337 6 38.8847 41.1446 10.3004 16.8495 57.0142 -12.497 +8338 4 38.6453 0.212884 10.3117 6.47193 -33.8599 -1.337 +8339 4 38.2374 40.7573 10.8541 -26.8649 -17.5582 22.9746 +8340 6 53.4109 21.9211 38.9712 27.3607 0.0645619 -10.5759 +8341 4 53.0384 21.9801 38.0859 -10.7304 2.2749 -0.0111998 +8342 4 54.3668 22.0571 38.7395 -19.1981 -5.88632 12.9741 +8343 6 39.9872 12.7205 36.288 -8.06793 35.3321 20.4333 +8344 4 39.087 12.3834 36.3725 1.18883 -9.13664 -3.11406 +8345 4 40.4905 12.1818 35.7009 7.36107 -20.124 -19.0601 +8346 6 48.4463 17.2389 40.5967 -24.7278 4.81563 12.4078 +8347 4 47.5665 17.6971 40.4852 25.7833 -12.0744 1.257 +8348 4 48.3987 16.886 41.5134 6.10343 4.05346 -12.6042 +8349 6 32.0413 9.35688 40.0251 1.84943 -9.41379 10.5137 +8350 4 32.8011 9.3156 39.4233 -4.71533 -3.42986 0.347912 +8351 4 31.8082 8.43016 40.2864 3.98001 20.4877 -6.20043 +8352 6 31.7351 22.4909 6.36481 -11.9835 4.517 5.86255 +8353 4 31.4453 21.6589 6.79738 2.31245 15.2673 -2.59345 +8354 4 31.3521 23.2372 6.88711 4.39127 -22.2776 -7.77946 +8355 6 51.0252 2.58567 21.5888 12.0252 -3.79771 4.1956 +8356 4 51.3852 1.69652 21.8042 -1.91984 13.1306 -1.09782 +8357 4 51.7712 3.19849 21.4753 -6.25067 -9.48202 2.92476 +8358 6 13.6387 22.0486 12.1519 25.289 13.6281 9.24284 +8359 4 14.4553 22.4795 12.4841 -9.12946 -7.35477 -7.44936 +8360 4 12.9422 22.6971 12.3091 -5.69931 -0.254566 -0.690626 +8361 6 23.6098 24.0343 14.6404 -2.85842 21.3712 -30.1324 +8362 4 24.3054 24.4792 15.1401 1.72137 -5.65962 3.08819 +8363 4 23.5196 24.6041 13.8393 -4.42688 -17.9982 21.1692 +8364 6 9.32217 4.85318 31.2328 11.4746 -4.61869 -4.10735 +8365 4 8.43042 4.86168 30.8848 -9.06213 4.49291 -0.279243 +8366 4 9.25495 5.26013 32.106 -3.85952 -1.36 2.0258 +8367 6 16.6786 26.3118 18.041 -30.5179 5.83101 -14.1852 +8368 4 15.8205 26.6594 17.6987 9.23568 -14.6779 7.38956 +8369 4 17.2149 27.0871 17.9121 20.6972 11.6613 1.32787 +8370 6 5.1068 13.5155 11.5503 -9.62018 18.629 -29.2057 +8371 4 4.37741 13.3629 12.1623 -7.62379 -0.222526 0.540006 +8372 4 4.70689 13.979 10.7366 10.5209 -18.4088 37.9064 +8373 6 29.6181 23.6359 8.06142 -1.81854 7.21422 -1.70755 +8374 4 29.1888 23.4521 8.90141 0.206013 -3.23773 -0.0922606 +8375 4 29.4815 24.5976 7.98987 7.61073 -10.2969 -5.72522 +8376 6 0.801466 7.54671 27.8401 6.5354 -3.49578 -14.7683 +8377 4 0.895859 7.27352 28.7573 1.78004 -0.979843 7.25552 +8378 4 1.54585 8.15528 27.6648 -11.1939 -10.5496 5.25649 +8379 6 15.4336 9.77253 0.489553 0.922542 4.3707 -1.35473 +8380 4 16.0351 9.34865 41.7726 4.14277 -6.55565 2.56274 +8381 4 15.4857 9.31476 1.34042 4.74784 -1.15717 -0.337147 +8382 6 18.8008 0.0730809 34.105 -10.3773 -6.96418 -21.8764 +8383 4 18.5081 41.5423 33.2731 5.22569 12.9238 15.5106 +8384 4 18.5071 0.998566 34.0742 -2.68781 1.40869 -5.2752 +8385 6 18.7326 30.7673 29.1559 48.9948 -22.8293 28.8452 +8386 4 19.5421 30.7479 29.7792 -35.6741 -9.01286 -31.0748 +8387 4 18.496 31.6741 29.187 -17.0068 24.787 -0.45657 +8388 6 48.459 16.4997 36.139 1.45519 10.5028 1.01521 +8389 4 47.6111 16.9857 36.2164 10.4415 -5.87096 -2.55811 +8390 4 48.4968 16.1176 35.2432 -2.18798 4.21486 5.30298 +8391 6 43.8007 0.467658 29.2569 28.3678 -13.8677 -3.77703 +8392 4 42.8971 0.305725 29.4937 -25.3214 -1.14832 5.94808 +8393 4 44.2622 41.5592 29.5347 -3.4854 12.8866 -0.12306 +8394 6 16.7282 13.8764 21.3804 -5.85841 5.25102 8.86173 +8395 4 16.2274 14.7005 21.5266 6.94274 -6.60805 -7.01164 +8396 4 16.607 13.4327 22.2267 1.29648 -4.09529 1.45702 +8397 6 17.3848 13.434 26.2514 27.8708 0.579352 -19.8612 +8398 4 18.2073 13.6243 25.7048 -28.5107 -7.2193 21.7409 +8399 4 17.5944 12.6077 26.718 -2.1357 3.12496 0.608863 +8400 6 48.1647 10.2208 23.7049 7.80266 -18.7522 13.388 +8401 4 47.9825 10.5204 24.6118 -3.05612 1.76991 -8.97221 +8402 4 48.0139 10.9468 23.1026 -1.19683 7.34816 1.26356 +8403 6 28.2773 17.9142 17.8758 3.72989 18.9709 -15.182 +8404 4 29.0682 18.432 17.6259 -4.1904 -8.84834 4.2635 +8405 4 28.5441 17.0749 18.25 8.7895 -11.8779 5.35139 +8406 6 54.0848 38.1774 23.6862 8.79068 2.20397 4.23058 +8407 4 0.0366427 38.003 23.4974 -14.1536 0.885634 -1.20583 +8408 4 53.5245 37.5494 23.203 6.54807 -0.952262 -0.611804 +8409 6 8.48984 18.3998 11.4055 -13.462 -3.57414 27.789 +8410 4 7.65602 18.6961 11.043 -9.38292 3.75479 -0.915161 +8411 4 9.09748 18.5243 10.712 30.3826 3.02886 -30.4498 +8412 6 45.9441 12.8818 11.0222 -16.4049 1.91652 -6.40765 +8413 4 46.711 12.6299 10.4835 -7.54952 -0.564906 -6.57768 +8414 4 45.1235 12.7466 10.4771 21.7466 0.735613 7.10643 +8415 6 16.2215 8.79448 14.033 27.9098 -14.9816 6.01142 +8416 4 15.5522 9.3752 13.7952 -53.829 20.9905 -11.5495 +8417 4 16.9359 9.40542 13.9326 31.9466 3.3348 3.59486 +8418 6 42.7223 13.3863 21.3918 29.8224 16.7773 6.64199 +8419 4 41.9142 12.8874 21.2836 -9.67718 -3.29752 -8.9243 +8420 4 42.6271 14.312 21.0975 -16.0363 -11.184 0.152454 +8421 6 20.9977 40.4228 16.4707 19.2311 -21.9074 5.84064 +8422 4 20.7341 40.0536 17.3362 -0.495629 5.04161 -8.05599 +8423 4 21.8212 39.937 16.2081 -24.2166 11.8961 5.45251 +8424 6 45.6397 11.4296 32.9439 38.4109 -29.1814 -9.99274 +8425 4 46.3321 10.7493 33.2028 -28.4056 24.9384 -5.22126 +8426 4 45.113 11.6624 33.7013 -7.79747 1.97566 18.4384 +8427 6 26.9602 8.8599 24.2968 13.5915 2.79356 4.8338 +8428 4 27.3951 9.75608 24.2837 -6.20264 -27.5971 5.81865 +8429 4 27.4821 8.2415 24.8764 -5.62896 20.549 -11.158 +8430 6 18.9707 2.44141 29.3655 -2.01209 17.0873 0.653095 +8431 4 18.2519 2.38593 30.0124 -1.45633 -1.83702 1.76482 +8432 4 19.0982 3.39915 29.1871 -0.208097 -9.69202 4.76181 +8433 6 8.2396 29.1642 19.724 -7.67611 -9.48635 17.3168 +8434 4 8.16332 28.9052 20.6672 2.00381 4.74558 -18.2193 +8435 4 7.79264 28.4685 19.2154 1.97612 2.42161 3.19163 +8436 6 9.03293 34.3085 18.6392 -6.8245 -3.51508 -5.57673 +8437 4 8.73043 34.3576 19.5508 2.61936 3.47829 -5.40237 +8438 4 9.19173 35.2194 18.3614 3.83285 -0.179546 -0.301582 +8439 6 10.1806 11.9309 11.2378 5.33181 -8.21116 5.18339 +8440 4 10.4199 12.8404 10.9987 -8.38943 -3.43734 -3.26379 +8441 4 9.2213 11.8063 11.1618 4.16708 15.3888 -2.40164 +8442 6 35.7388 21.6853 36.1571 -21.2187 21.2566 3.59668 +8443 4 35.0074 22.3505 36.1843 15.9506 -16.0405 0.715421 +8444 4 36.3839 21.978 36.8321 -7.05156 -5.2756 -8.86951 +8445 6 17.0774 12.5078 36.39 -5.14261 15.8003 12.7424 +8446 4 17.3404 12.7479 37.2961 -4.35419 -1.09545 -7.6232 +8447 4 17.4977 11.6659 36.234 4.71638 -15.3379 -7.50181 +8448 6 37.1607 13.034 34.2837 0.889917 6.85814 -56.1323 +8449 4 36.6144 12.2451 34.135 3.16712 2.80772 8.73621 +8450 4 37.2953 13.1592 35.1962 -1.91867 -3.10361 40.6259 +8451 6 38.9747 29.5563 13.2253 1.18838 24.1885 -12.4362 +8452 4 38.8174 28.6959 12.8484 -2.87796 -16.626 0.178868 +8453 4 38.7606 29.548 14.1582 -0.666122 -3.30753 9.89159 +8454 6 0.17037 29.343 29.4884 -1.26324 3.91124 -27.2421 +8455 4 0.785297 28.6867 29.1327 1.78511 -2.78426 6.40223 +8456 4 54.9717 29.8735 28.6813 -2.47422 -4.8209 18.3172 +8457 6 15.9286 0.264913 12.7638 2.77369 8.97324 -0.606717 +8458 4 15.3998 0.564835 11.9867 -4.35739 -9.72902 15.1241 +8459 4 15.3918 41.7399 13.4663 -4.26125 7.58409 -15.055 +8460 6 3.98508 11.9472 8.79546 -10.0423 -23.9471 10.8905 +8461 4 4.30821 11.7435 7.92681 6.40121 -7.70989 -16.6116 +8462 4 3.96465 12.8834 8.77069 -2.75643 37.1798 9.03734 +8463 6 24.0517 23.6768 19.9772 9.9875 -0.396554 0.578582 +8464 4 23.5025 22.9354 19.7663 -8.47693 -16.0962 -5.40355 +8465 4 23.4442 24.2751 20.4024 2.14545 13.6845 6.88162 +8466 6 4.48152 2.30986 23.9923 -27.0109 23.4084 27.373 +8467 4 4.59263 2.40669 23.0716 9.73085 -3.6317 -36.525 +8468 4 3.6479 2.81506 24.1139 10.3345 -10.6947 10.8816 +8469 6 33.0856 27.6588 33.8383 -8.68317 -6.77689 0.893276 +8470 4 33.3543 28.5605 33.6822 -2.66039 14.7626 -6.22211 +8471 4 33.7694 27.2718 34.3804 4.93538 -5.90298 8.33006 +8472 6 11.4012 21.7076 6.08442 -20.9181 -7.28975 6.20623 +8473 4 12.3452 21.6439 6.06884 23.6791 -0.506282 -5.12853 +8474 4 11.1369 22.1078 5.25059 3.06155 -0.534748 -3.52863 +8475 6 37.2275 13.5312 23.6107 -13.7454 14.8127 9.96245 +8476 4 37.2011 14.0176 24.4689 -4.04457 -8.03454 -15.7104 +8477 4 38.0738 13.1109 23.5305 19.2281 -7.80113 -1.86698 +8478 6 5.00929 21.0475 33.3676 1.03993 27.0325 -33.9401 +8479 4 4.24931 21.2691 32.771 13.0002 -8.94008 10.7478 +8480 4 4.70945 20.492 34.0664 -10.4226 -16.4153 18.9759 +8481 6 18.2024 37.5737 26.9347 11.0126 -1.54132 -8.69207 +8482 4 17.8515 38.4557 27.1129 2.92195 -1.85995 -3.39903 +8483 4 18.9058 37.6892 26.2602 -8.80934 -3.84756 9.96821 +8484 6 19.7475 16.1502 4.67922 -0.59461 -5.69737 6.80756 +8485 4 18.938 15.9829 5.17999 -0.503733 6.42822 -3.53139 +8486 4 20.452 15.899 5.29485 1.51569 2.54074 -3.7554 +8487 6 54.0588 32.502 15.5791 2.11509 -30.3723 -27.0265 +8488 4 54.9193 32.2734 15.944 -2.03587 2.87368 2.60187 +8489 4 53.7148 33.1889 16.1175 -9.21817 24.1266 16.9863 +8490 6 31.1319 3.81908 36.7331 -8.52453 -12.3767 5.98224 +8491 4 31.0251 4.01663 37.6709 2.24281 6.85123 1.97341 +8492 4 30.7371 2.93942 36.6325 4.48759 4.53933 -4.77061 +8493 6 11.8397 14.3559 5.95013 17.712 13.5011 32.6048 +8494 4 11.8882 13.4483 5.64785 3.21485 -4.29204 1.16864 +8495 4 12.4103 14.428 6.79608 -23.3682 -9.2254 -38.5841 +8496 6 30.4732 33.6903 6.46877 -20.5926 30.9984 10.0988 +8497 4 30.0823 33.146 7.15741 -0.571027 -8.82817 5.88036 +8498 4 31.0368 33.1406 5.95739 18.3645 -25.6031 -16.3825 +8499 6 12.7874 0.539502 21.6719 -8.5062 -5.44338 -19.1545 +8500 4 12.0427 0.939271 21.1459 16.6961 -1.79193 22.1421 +8501 4 12.8959 0.982969 22.5241 -5.23507 7.86641 1.50036 +8502 6 52.7588 7.2218 26.198 16.8025 28.3515 6.33153 +8503 4 53.4065 7.96379 26.3423 -21.978 -17.2249 -4.05545 +8504 4 53.0631 6.80021 25.3976 -2.37526 -6.61619 -6.13258 +8505 6 39.7335 40.8867 3.73325 7.25622 8.93714 -16.4459 +8506 4 39.3445 40.0379 3.8542 -7.03998 -23.1188 -2.87281 +8507 4 39.6833 41.2661 4.59764 3.93702 15.0893 17.324 +8508 6 20.121 31.9222 21.9838 -6.71526 -6.20654 6.86321 +8509 4 19.4522 31.9772 22.708 13.7594 -4.46219 -12.9776 +8510 4 20.3423 32.8279 21.7497 1.41177 8.86705 -0.575134 +8511 6 12.8675 35.0031 4.45346 44.828 -17.7313 4.60062 +8512 4 12.2237 35.6716 4.40701 -39.658 29.9319 -2.18346 +8513 4 13.7076 35.4677 4.24983 -7.53722 -6.26381 -0.0905995 +8514 6 24.0625 33.6591 24.8433 7.47563 8.71661 -6.22666 +8515 4 23.7256 32.9086 24.3593 -5.011 -9.84395 -6.229 +8516 4 24.8651 33.8891 24.3525 -1.08488 0.504411 0.449776 +8517 6 40.1566 40.8925 22.745 3.65995 -18.1772 23.084 +8518 4 39.459 41.1173 22.1514 -10.4135 8.7075 -19.9273 +8519 4 39.655 40.5713 23.5068 11.7186 -0.819555 2.88668 +8520 6 15.5608 2.83174 38.4548 -17.961 4.93292 18.3513 +8521 4 14.8017 3.44348 38.6509 23.1729 -8.01231 -13.692 +8522 4 16.317 3.27039 38.0376 1.48109 9.53369 -0.90723 +8523 6 41.0116 9.17543 16.9495 15.4695 -4.08523 -13.4682 +8524 4 41.9148 8.77619 16.8957 -14.8555 5.86712 4.74383 +8525 4 40.5932 8.80873 17.73 -3.00249 -3.47282 8.63794 +8526 6 43.1871 41.3934 9.57744 -8.69666 -18.4537 3.1119 +8527 4 42.3844 40.9156 9.26306 10.8189 9.37287 1.53096 +8528 4 43.2581 0.273962 9.04681 -5.03874 9.79533 -5.6553 +8529 6 24.9044 37.9223 30.7828 -39.5154 -3.84946 22.9815 +8530 4 23.9949 37.8093 31.2426 42.0603 4.56965 -20.1335 +8531 4 24.7148 38.3736 29.9542 -2.24489 2.04808 -5.58176 +8532 6 2.22015 5.33054 16.4399 10.309 -8.52293 4.98471 +8533 4 1.84892 4.56193 16.8809 -9.36945 -1.25887 4.31387 +8534 4 3.13742 5.05729 16.2666 0.349453 6.20437 -4.74718 +8535 6 1.39717 14.946 19.1428 25.1228 15.6369 3.14315 +8536 4 0.624759 14.5201 18.7755 -11.3456 -6.79531 3.66607 +8537 4 1.29195 14.9418 20.1112 -7.64559 -2.97115 -5.19376 +8538 6 34.323 26.551 23.7054 -6.89575 15.1076 -7.90432 +8539 4 33.5377 26.6273 23.1515 0.482254 10.7241 -2.26295 +8540 4 34.2298 25.6735 24.0419 5.3831 -21.6418 13.1607 +8541 6 41.9187 21.8289 37.5387 -12.5221 18.6557 -0.654717 +8542 4 42.0641 21.2774 38.3263 -4.73604 7.9145 -4.0056 +8543 4 41.3184 22.5612 37.831 11.9642 -17.2916 1.51119 +8544 6 39.4187 37.6728 12.6286 4.8532 5.57593 -2.65087 +8545 4 38.7905 38.0203 13.2933 13.4683 3.10916 -9.30227 +8546 4 40.0129 38.4033 12.3216 -17.7433 -13.1833 12.1033 +8547 6 30.24 35.8848 2.88572 49.7685 -5.59713 18.4489 +8548 4 29.7974 35.0543 2.80033 -9.93294 -19.906 -6.06696 +8549 4 29.6668 36.5692 2.63166 -32.6151 32.1739 -11.9765 +8550 6 50.3574 12.2906 11.0327 -10.5999 -17.0186 -10.0309 +8551 4 50.5337 13.0768 11.5186 9.60091 28.0994 7.49192 +8552 4 50.105 11.6994 11.7365 -4.43527 -18.2768 5.14926 +8553 6 38.4177 1.51331 34.6454 7.78381 -17.0522 33.0946 +8554 4 38.2699 2.04814 33.8899 -7.54861 16.9144 -29.9652 +8555 4 38.0471 0.642488 34.4678 -6.5188 -5.83242 -9.72252 +8556 6 23.4539 32.2409 29.2188 -19.2438 22.9381 45.5983 +8557 4 24.0079 32.8299 28.7229 8.54827 0.527122 -15.0299 +8558 4 23.2413 32.797 30.0413 4.80705 -31.5817 -31.7916 +8559 6 36.5701 38.8746 8.90535 32.3223 -9.33237 29.2552 +8560 4 35.9325 39.4424 8.49935 -20.4423 23.0824 -8.61697 +8561 4 36.7801 39.1579 9.82993 -12.7327 0.605838 -19.3651 +8562 6 35.8737 15.8498 32.4386 8.92141 19.9053 -4.5399 +8563 4 36.1418 15.4504 33.2665 1.19933 -3.86396 7.25653 +8564 4 36.5179 16.5897 32.2945 -14.9335 -15.4114 1.1633 +8565 6 22.2892 21.8291 41.5841 -16.2626 10.7882 17.5339 +8566 4 22.1223 22.8053 41.6744 16.5914 -23.4811 -7.73209 +8567 4 23.1242 21.6534 41.1409 10.4107 9.35007 -4.50107 +8568 6 24.3606 38.6964 37.0146 17.4204 12.5043 -4.63866 +8569 4 25.2779 39.064 36.9978 -17.1771 -5.52971 -1.04157 +8570 4 24.4186 37.9719 37.6407 -4.78215 -9.12154 5.30794 +8571 6 45.8441 22.068 16.038 0.340293 -0.250982 -17.8101 +8572 4 46.1771 22.3609 15.1533 -8.50833 -8.1377 19.1007 +8573 4 45.4344 21.1785 15.9468 10.2139 13.0315 -4.03882 +8574 6 34.0918 26.1359 39.6112 38.0511 -8.91464 13.1738 +8575 4 33.1848 26.2338 39.3827 -25.4265 4.60567 1.8853 +8576 4 34.221 26.2032 40.5833 -12.0295 -1.62025 -11.2558 +8577 6 7.22533 36.1661 23.281 -59.3132 -5.14125 -34.652 +8578 4 7.26364 37.0581 22.9295 6.20379 9.34593 -2.3157 +8579 4 7.97006 36.0735 23.8015 59.451 -4.11437 40.0555 +8580 6 29.1637 40.7448 9.14206 -2.51826 7.72751 -13.9009 +8581 4 29.0444 40.3656 8.22324 15.9504 -2.90487 33.8878 +8582 4 29.7314 40.248 9.77766 -4.36215 -9.31282 -20.9127 +8583 6 29.3678 11.2357 1.30083 -35.1077 14.24 19.1284 +8584 4 28.4669 11.4731 0.940057 29.2946 -5.02339 11.2991 +8585 4 29.318 11.4379 2.27092 4.83193 -7.95866 -28.0539 +8586 6 30.9732 3.71267 14.0776 15.2348 -46.8383 -31.5788 +8587 4 31.4582 2.88428 14.3733 -12.5046 34.6753 7.46482 +8588 4 30.8397 3.49874 13.1133 -3.67459 15.4991 23.3176 +8589 6 29.7056 15.2804 38.2794 -11.9618 14.5562 -33.6413 +8590 4 30.2702 15.1354 39.0168 20.1567 -4.59268 23.419 +8591 4 30.0841 16.0123 37.7308 -6.59039 -15.0688 15.6005 +8592 6 36.6264 0.310111 29.1514 -5.04796 -7.83703 -2.09784 +8593 4 37.4271 0.819379 29.3706 -8.93441 4.46737 -4.0897 +8594 4 35.9914 0.856083 28.6484 15.2391 -5.29618 7.37908 +8595 6 47.6417 0.116275 23.248 13.5287 8.94531 -12.2883 +8596 4 47.0119 0.433387 23.8864 -15.3927 3.59754 12.8324 +8597 4 47.4641 41.0946 23.1357 -2.49679 -12.2922 2.24912 +8598 6 7.90637 37.1762 29.9388 8.54368 22.8184 26.8453 +8599 4 7.85301 37.2098 30.9449 3.45275 -3.37357 -41.2712 +8600 4 8.44496 37.9737 29.6897 -17.0006 -23.7003 10.0801 +8601 6 38.9296 24.2329 12.6383 15.5219 -16.6974 -22.776 +8602 4 37.9787 24.1601 12.7323 -9.9748 0.376678 1.49713 +8603 4 39.1449 23.5705 11.9215 -5.67631 22.059 20.3409 +8604 6 21.3179 26.2613 36.7933 11.7928 19.07 -1.51604 +8605 4 20.8397 25.6962 36.2015 -9.60619 -6.53459 -13.3894 +8606 4 21.5182 25.6957 37.5187 2.0605 -10.1459 21.1123 +8607 6 28.2262 23.3351 24.9913 6.08955 -0.748437 0.460504 +8608 4 28.2308 24.0016 25.6964 4.22655 -6.81745 -1.24962 +8609 4 29.0479 22.8075 25.0363 -13.73 7.51762 2.95505 +8610 6 38.3897 39.5713 14.5774 34.0997 -9.77678 18.0089 +8611 4 38.4779 38.8655 15.2987 -6.58584 29.8461 -29.0755 +8612 4 39.3026 40.0121 14.5422 -41.1029 -19.3921 -1.23505 +8613 6 26.0587 6.01626 38.1331 -7.56489 -16.2073 9.45163 +8614 4 26.364 6.92283 38.0032 14.5247 -0.467326 2.92393 +8615 4 26.7573 5.38712 38.4414 -3.391 26.9876 -7.34507 +8616 6 52.1178 17.2513 22.5128 -10.8492 5.54118 7.42996 +8617 4 52.8997 17.6733 22.1718 9.92427 15.7211 -4.0445 +8618 4 52.2219 16.3395 22.2718 -2.102 -18.0313 -4.16051 +8619 6 39.531 30.2011 31.4754 1.32431 5.33104 20.3977 +8620 4 40.1389 30.6029 32.1578 -26.1612 -12.9519 -10.6425 +8621 4 38.6407 29.9778 31.8528 28.462 12.4065 1.81878 +8622 6 19.6595 6.91666 12.7659 -14.5008 4.80913 14.0157 +8623 4 19.6887 6.47111 13.6446 7.23462 -2.42447 -18.0556 +8624 4 20.266 6.55226 12.115 5.2883 -10.9354 6.21868 +8625 6 32.4266 37.4954 40.1172 13.7501 31.88 -47.4625 +8626 4 32.7425 36.6266 39.9032 -2.48661 -20.9779 5.59445 +8627 4 32.1419 37.5817 40.9958 -11.8933 -10.3197 48.8363 +8628 6 39.7596 0.337115 6.09995 15.1421 -1.66777 24.2876 +8629 4 40.1534 1.22219 6.08152 -5.11901 -0.972083 -7.53812 +8630 4 40.1657 41.8549 6.90018 -9.37436 -2.20237 -11.3555 +8631 6 28.7751 10.1584 29.138 -2.01192 2.80513 -2.93319 +8632 4 27.8238 10.1744 29.001 -3.57801 1.81269 -4.50746 +8633 4 28.8919 9.80572 30.0274 6.34341 -2.0407 -1.56061 +8634 6 28.3442 21.074 10.6333 2.67716 -1.32955 -8.08167 +8635 4 28.7162 21.9756 10.7458 1.68682 -14.6392 -2.70928 +8636 4 28.9848 20.5267 10.1317 -8.30024 16.2649 10.4277 +8637 6 27.0693 28.6863 20.8775 28.7719 -2.37794 4.3254 +8638 4 27.7298 29.2434 21.3283 -4.93173 -3.86203 -1.8773 +8639 4 26.2334 28.9344 21.2444 -24.6691 6.36732 10.1211 +8640 6 39.6873 13.9804 33.4544 10.1398 -5.61125 10.7915 +8641 4 40.0465 13.7022 34.3167 -4.86 2.4669 -10.6871 +8642 4 38.7726 13.6755 33.4723 -5.1401 -2.85022 0.606476 +8643 6 25.4597 11.6576 34.3181 14.491 -28.0098 33.8508 +8644 4 24.8514 11.0162 34.7619 5.36553 12.2612 -15.2396 +8645 4 25.0161 12.1454 33.6493 -21.152 12.7672 -16.4478 +8646 6 27.5131 37.6326 21.427 -19.9573 -21.9997 -23.7283 +8647 4 28.2253 37.2064 20.96 8.67225 -9.05343 -17.242 +8648 4 27.9596 38.068 22.1137 20.557 20.5047 35.0331 +8649 6 30.5914 20.0695 28.6348 27.7431 -17.6396 19.2377 +8650 4 30.9836 19.3645 29.1801 11.8534 20.0629 -12.5158 +8651 4 29.6982 19.8076 28.6872 -39.6618 5.20089 -10.7407 +8652 6 42.3778 1.85684 14.9393 25.4983 -1.50621 30.9456 +8653 4 41.9471 2.41032 15.6124 -5.43016 1.03086 -4.74891 +8654 4 41.8361 1.80616 14.1675 -19.8596 2.00334 -17.6468 +8655 6 12.1616 12.5321 19.523 -14.5305 -6.69845 -4.01711 +8656 4 12.9939 12.0448 19.446 -0.641831 -5.10207 -0.17564 +8657 4 11.4028 11.9007 19.4323 17.6183 8.93718 0.635936 +8658 6 19.2173 1.21358 16.3673 12.2327 1.89672 9.92834 +8659 4 19.755 0.600796 16.911 -5.77615 9.45405 -9.5745 +8660 4 19.8129 1.9499 16.1364 -2.75311 -6.47505 -0.557351 +8661 6 9.48027 16.145 27.6887 18.4383 23.7652 -21.1678 +8662 4 9.95062 16.009 26.8224 -12.6846 -2.19341 25.2173 +8663 4 9.19893 15.3052 28.0262 -3.30777 -17.5687 0.945009 +8664 6 40.4566 26.1709 24.7821 -20.4805 41.2174 -0.532491 +8665 4 40.3628 26.7039 25.5991 10.1463 -19.7663 1.05084 +8666 4 40.0809 26.8306 24.1463 10.2053 -25.1837 1.88999 +8667 6 47.6675 17.6506 18.0225 -30.0634 41.3074 12.2788 +8668 4 48.2543 17.9981 18.7254 0.401995 -10.3127 -9.33209 +8669 4 46.9068 18.3177 18.0388 29.0716 -28.5939 -1.2112 +8670 6 36.6158 25.2629 4.18774 29.3736 28.0527 4.32129 +8671 4 36.5214 25.5758 5.09839 -16.0305 -5.04511 0.138651 +8672 4 37.2819 25.9232 3.86538 -16.6324 -17.2389 -6.3952 +8673 6 39.5728 35.3879 29.6636 12.278 22.7044 -7.26925 +8674 4 39.0499 34.5938 29.661 -5.91236 -8.06683 2.48368 +8675 4 39.3907 35.9006 30.4607 -1.7908 -9.53931 -1.38728 +8676 6 0.412001 14.6096 13.3342 2.26376 -2.5079 -14.7045 +8677 4 54.7802 15.2759 13.6175 -3.32355 6.27336 -0.974202 +8678 4 0.516441 14.0579 14.0961 4.60085 -12.9246 15.0473 +8679 6 12.196 27.3305 8.43326 10.0473 13.6833 14.0535 +8680 4 13.031 26.8669 8.51701 2.31971 -16.5604 -6.51009 +8681 4 12.4357 28.1833 8.85089 -17.0888 -3.60228 -10.1051 +8682 6 36.9057 14.8161 21.1198 30.6025 20.2317 -25.7914 +8683 4 37.0125 14.4244 21.9807 1.92342 -10.2074 20.832 +8684 4 37.7936 15.2053 20.874 -24.9082 -16.5351 5.08732 +8685 6 20.8486 4.94275 21.105 17.9022 -6.61396 -0.309651 +8686 4 20.374 5.67415 21.5228 9.17185 2.06744 3.08402 +8687 4 21.7751 4.88103 21.448 -24.8745 1.45604 -2.42669 +8688 6 36.7441 1.80601 7.63303 -8.86792 14.8212 -18.8361 +8689 4 36.3577 2.71345 7.77493 14.0998 -30.8697 16.0099 +8690 4 36.9898 1.34966 8.45182 -6.21638 14.7491 3.51078 +8691 6 12.2291 31.5076 37.4606 -20.8205 4.71929 16.9336 +8692 4 12.7789 31.2189 36.7301 -1.71439 -5.19212 -6.77065 +8693 4 11.3837 31.0118 37.4916 13.4088 3.21935 -3.86138 +8694 6 38.9875 41.6041 16.8806 -4.97036 -4.86794 -9.64455 +8695 4 39.4307 41.5716 16.0177 3.10466 0.790549 7.7281 +8696 4 39.367 0.410173 17.3903 6.57234 9.13046 2.45051 +8697 6 31.8971 27.2651 22.2536 0.475946 9.95506 -26.8482 +8698 4 31.2288 26.6192 22.5148 1.53167 3.01995 -0.700727 +8699 4 31.6701 27.5469 21.3168 1.33988 -13.0026 32.8364 +8700 6 42.7373 9.18402 25.5752 -16.5205 -8.12573 12.5156 +8701 4 42.0715 8.82875 24.9549 8.97347 3.93682 -3.18445 +8702 4 43.4726 9.55718 25.0966 9.17117 4.66181 -14.1392 +8703 6 50.9317 28.1762 25.3585 1.81467 11.9603 16.0249 +8704 4 50.4332 27.6858 24.699 -7.797 -4.30978 2.61883 +8705 4 50.6061 27.9816 26.259 1.82058 -3.16123 -16.2825 +8706 6 43.2019 19.6758 30.9261 -60.5069 12.608 18.1565 +8707 4 44.1121 19.7947 30.8273 58.227 11.7487 -4.80009 +8708 4 42.8317 20.4979 31.3452 14.2318 -14.5845 -6.94071 +8709 6 30.6579 14.0392 40.8099 -3.90856 28.8453 32.4485 +8710 4 30.2625 14.437 41.6588 6.78025 -22.1962 -33.7862 +8711 4 30.2388 13.192 40.6401 -8.31431 -9.09038 5.19898 +8712 6 20.9126 15.487 23.0255 1.81996 -1.2716 -0.577536 +8713 4 20.3529 16.1851 23.4151 9.86352 -5.06847 -1.26552 +8714 4 21.845 15.6804 23.2451 -11.0139 0.781722 1.09061 +8715 6 34.2266 0.759926 35.8266 5.91607 -35.831 36.3238 +8716 4 34.6699 1.4486 36.3596 -6.19332 -9.6922 -6.67054 +8717 4 34.0788 41.8551 36.4474 5.42693 41.8664 -30.5853 +8718 6 38.9146 36.9114 35.918 21.2173 -10.8751 17.2864 +8719 4 39.7829 37.095 36.338 -12.434 5.66027 -11.9648 +8720 4 38.7157 36.033 36.27 -5.46808 2.11761 -7.10044 +8721 6 45.1412 25.209 22.7799 -9.21588 11.7282 35.1943 +8722 4 44.1635 25.1535 22.9277 18.3683 -4.67801 -8.38153 +8723 4 45.395 24.8019 21.9606 -9.08047 -9.94082 -17.9945 +8724 6 40.6079 0.819632 35.9543 -10.1658 30.0784 -5.29357 +8725 4 40.5743 41.7978 35.9297 8.39322 -37.6139 4.80851 +8726 4 39.8853 1.04128 35.3423 10.5918 6.58535 9.58714 +8727 6 11.0481 28.354 35.0263 -7.05837 2.15472 6.15391 +8728 4 11.0065 27.7661 35.7937 6.20016 -1.50115 -1.31869 +8729 4 10.2774 28.923 35.1598 -2.00076 2.29074 -4.05614 +8730 6 20.214 13.5993 35.8619 28.0429 -16.4719 23.5579 +8731 4 19.4963 13.9327 35.3857 -45.1468 12.1599 -23.9045 +8732 4 20.9404 14.0304 35.4284 21.7873 4.64258 -6.99651 +8733 6 39.6259 5.13927 1.77541 6.3837 10.5905 23.0009 +8734 4 38.815 4.76887 1.43754 -8.89155 -4.8304 -7.9643 +8735 4 40.2998 5.10051 1.09544 5.70124 1.55861 -13.0764 +8736 6 30.2644 30.8765 32.4376 2.45351 13.5189 11.7538 +8737 4 29.6638 31.1848 33.1457 1.37952 -7.29152 -6.97913 +8738 4 29.9065 30.0722 32.0512 -6.5155 -7.29863 -0.0927806 +8739 6 14.5561 10.991 22.8667 10.081 16.7623 43.7388 +8740 4 15.1677 11.6459 23.3133 -13.9792 -18.4015 -26.7579 +8741 4 13.9431 10.829 23.6181 3.59137 -7.6484 -17.8174 +8742 6 20.7554 13.9367 3.0184 -22.7431 -13.2276 -14.851 +8743 4 19.9027 13.7405 2.57467 24.082 -4.954 3.77469 +8744 4 20.4786 14.7044 3.49738 5.42185 19.6619 18.2233 +8745 6 41.2999 4.28373 12.6115 -5.11846 11.2121 16.06 +8746 4 40.5902 3.66826 12.7964 -5.45414 -3.74116 2.1628 +8747 4 41.646 4.04628 11.766 6.8814 -9.70345 -22.8074 +8748 6 10.8486 24.7151 21.7079 -22.0181 20.7635 -2.99902 +8749 4 10.06 25.055 21.1824 26.1755 -20.3138 8.68391 +8750 4 11.196 23.8735 21.3742 -8.74412 -0.217035 -8.2032 +8751 6 53.5851 20.8962 34.3615 -20.5776 4.99959 -7.54911 +8752 4 54.5312 20.9399 34.3174 23.7346 3.60458 -0.717784 +8753 4 53.3344 20.0378 34.731 7.46747 5.54606 -4.26157 +8754 6 14.8822 4.84805 30.4483 -9.71325 -6.00753 -19.6684 +8755 4 14.771 4.94284 29.4789 1.77408 0.90497 14.7496 +8756 4 14.5561 3.94513 30.5986 4.49673 6.24836 5.5759 +8757 6 48.9024 37.1196 13.1149 -36.5603 24.8322 -14.1851 +8758 4 47.9606 37.2057 13.4129 22.1922 -3.12109 -3.19476 +8759 4 49.2987 36.4589 13.6532 13.3268 -16.5999 12.901 +8760 6 26.8059 19.3169 7.54434 -4.26945 -4.42367 7.83904 +8761 4 27.1766 18.4867 7.22339 -3.92405 -4.32352 -1.07463 +8762 4 27.3968 19.9842 7.20607 8.782 12.6164 -5.40832 +8763 6 17.6305 11.9358 39.0864 -20.6439 9.19078 16.9487 +8764 4 18.5077 11.609 39.0209 28.8526 -12.5757 -8.06323 +8765 4 17.5232 12.1203 40.0373 -6.81014 1.23205 -8.73836 +8766 6 49.927 14.591 8.61416 15.5742 -26.1486 -8.96269 +8767 4 49.2009 13.9524 8.72368 2.87529 10.9098 3.94828 +8768 4 49.6414 15.4659 8.85563 -10.1676 20.5637 7.32703 +8769 6 32.3582 34.9735 31.5167 -0.414276 11.4895 24.1707 +8770 4 32.1283 34.3825 30.8126 -1.81559 -4.89127 -12.898 +8771 4 32.4479 35.8663 31.1601 -0.97656 -3.19104 -3.1743 +8772 6 11.821 22.2226 21.3194 1.12988 -20.2292 -31.7924 +8773 4 12.2035 21.6949 20.5593 -17.646 16.3031 19.3587 +8774 4 12.5076 22.1609 21.967 14.4856 1.86701 17.8995 +8775 6 33.8479 9.95925 13.6297 5.85555 4.94861 0.641841 +8776 4 32.9412 9.60258 13.4965 20.4646 2.44791 -13.0803 +8777 4 34.46 9.81143 12.8638 -25.0852 -4.3509 9.75457 +8778 6 25.5216 36.3896 1.4985 -3.83916 -1.90754 -5.44184 +8779 4 26.1733 36.851 0.947779 -3.43756 3.58217 3.68691 +8780 4 24.6678 36.8514 1.38848 10.8858 -3.23471 -1.95008 +8781 6 26.2654 10.5456 9.75524 -44.5011 8.64206 25.1655 +8782 4 25.6084 11.269 9.60979 18.788 -4.56637 -6.88642 +8783 4 25.8198 10.0845 10.5139 21.0346 7.54764 -16.1236 +8784 6 25.0247 0.792222 40.9035 16.6629 9.7536 -9.8108 +8785 4 25.2766 0.410293 40.0414 -7.0744 -0.853038 7.71488 +8786 4 25.4535 1.67289 40.8914 -6.39875 -10.0211 5.33714 +8787 6 46.2514 3.92331 24.811 2.29787 -10.4124 3.565 +8788 4 46.4476 4.07649 23.8793 1.84574 -7.0337 -1.43198 +8789 4 46.0806 2.96577 24.928 -3.00701 8.9366 -8.52535 +8790 6 21.593 13.605 29.211 2.46069 1.87638 12.7155 +8791 4 21.5518 14.2847 29.9136 -0.977025 -6.07097 -8.18011 +8792 4 21.3035 14.062 28.4178 -1.02829 3.62716 -1.29843 +8793 6 36.772 38.3747 0.364057 -13.57 -14.6746 -5.92565 +8794 4 36.4241 39.1227 0.863015 -2.10343 5.30459 -0.282121 +8795 4 36.0255 37.7419 0.250491 13.2024 11.0478 3.68109 +8796 6 19.3024 17.6377 24.0664 34.4056 30.1631 -22.0465 +8797 4 18.4191 17.3498 24.1437 -40.9446 -15.7866 5.54764 +8798 4 19.2946 18.2748 23.3003 0.347271 -14.2409 17.5238 +8799 6 23.1729 12.6936 3.50527 -23.4203 -1.67393 -9.32385 +8800 4 22.2599 12.987 3.28408 10.1497 2.83055 6.60862 +8801 4 23.2366 11.8468 3.05081 2.04707 -0.882582 2.79058 +8802 6 37.8929 8.88926 35.4532 -15.1513 -19.5409 -35.7954 +8803 4 38.8496 8.85033 35.2802 -3.80753 -1.00094 -0.145651 +8804 4 37.4409 8.32345 34.738 24.7998 24.8105 28.8968 +8805 6 14.3214 15.124 36.1936 10.1777 -8.45579 -11.337 +8806 4 15.1189 15.6285 36.3983 0.383997 -0.909139 3.4786 +8807 4 13.728 15.2114 36.9249 -8.84751 6.7001 14.2991 +8808 6 35.0764 0.951221 33.027 4.39995 -0.747562 -23.3066 +8809 4 34.9707 1.92678 33.0471 -0.901583 -14.825 16.9845 +8810 4 34.929 0.489106 33.8671 -4.79444 18.9729 2.67887 +8811 6 50.9368 0.508345 17.9996 -16.1068 -2.11236 -10.8013 +8812 4 50.7363 1.3993 17.6607 6.59543 -7.82408 5.75367 +8813 4 50.2126 41.8571 17.6452 15.113 5.01242 7.08044 +8814 6 26.2276 30.5707 0.943679 2.98972 25.4521 29.679 +8815 4 26.9747 31.0717 1.30878 -11.5718 -5.07384 -0.177367 +8816 4 26.5685 30.1289 0.190254 7.28539 -15.5247 -23.6744 +8817 6 18.5631 38.2963 4.56281 15.0547 -0.00169581 -1.07608 +8818 4 17.6313 38.4808 4.44067 -9.04909 6.52025 -3.84653 +8819 4 19.0145 38.7079 3.79419 -7.75189 -5.39823 9.30868 +8820 6 31.1327 5.08368 4.10816 20.0095 -18.3558 -6.33253 +8821 4 31.8391 4.51927 4.54922 -26.0459 18.0586 -17.7145 +8822 4 31.2112 4.96997 3.12633 -1.20575 2.29654 19.098 +8823 6 26.4386 21.9021 1.48262 11.6176 -12.3641 -2.34526 +8824 4 26.4119 22.77 1.11333 -7.24657 26.8604 -8.21156 +8825 4 27.3591 21.6321 1.37052 -1.3799 -4.61827 0.12427 +8826 6 39.218 11.6975 22.8013 10.5737 17.0434 4.86912 +8827 4 39.8837 11.6898 23.5135 -8.12783 -9.21376 -3.17514 +8828 4 38.7576 10.8611 22.7762 -0.316566 -9.51531 5.7902 +8829 6 13.6104 36.3454 30.6448 12.2201 31.8005 15.4331 +8830 4 13.9411 37.0787 31.1944 -5.64032 -6.12374 -20.8561 +8831 4 13.4819 35.6769 31.3099 -5.82879 -19.5305 -1.97286 +8832 6 50.5737 9.8729 9.34449 -28.5439 -15.8542 -0.594603 +8833 4 49.6941 9.5296 9.68217 24.5077 10.0039 -8.16891 +8834 4 50.7802 10.6382 9.87905 1.56032 8.49656 8.37591 +8835 6 49.6568 40.2957 22.5808 3.13406 -4.17489 -1.45496 +8836 4 49.9643 39.4131 22.2832 -6.04563 10.523 5.74674 +8837 4 49.4657 40.2311 23.537 6.08697 -6.10842 -7.72776 +8838 6 7.19984 41.3227 28.8903 -1.52952 20.6044 28.9443 +8839 4 7.18166 41.5789 29.8666 2.82963 -8.74683 -37.3978 +8840 4 7.33954 0.237732 28.3754 1.09714 -11.2116 9.436 +8841 6 13.0357 18.018 25.3358 19.442 16.9905 44.3108 +8842 4 13.6166 18.1186 24.5548 -1.12298 4.17303 17.3747 +8843 4 13.5323 18.3306 26.2146 -21.9746 -20.4015 -59.5043 +8844 6 50.052 19.589 2.43093 38.9512 -4.48133 -22.8803 +8845 4 50.7424 19.2598 1.79532 -23.4729 1.49397 14.1456 +8846 4 50.5528 20.298 2.8491 -7.87613 8.00017 8.65361 +8847 6 28.349 40.9814 24.5177 14.9096 -9.01222 -0.77751 +8848 4 28.8235 40.5955 23.7606 -4.31864 4.07524 4.80921 +8849 4 27.7156 41.5877 24.1507 -14.6867 11.3415 -7.76415 +8850 6 19.4129 5.36023 29.5381 -15.1481 -17.3665 11.3948 +8851 4 20.1134 5.96028 29.2689 3.1753 8.4576 0.913483 +8852 4 18.7407 5.8353 30.064 8.44892 1.72514 -6.85652 +8853 6 35.3149 40.1584 22.2743 -5.4761 3.67764 -22.0922 +8854 4 35.6772 39.8166 23.0859 3.70556 0.822605 11.3301 +8855 4 35.3088 41.1243 22.2924 6.6179 -0.993945 11.5959 +8856 6 16.1846 33.7767 9.75922 -0.358556 8.53088 17.0233 +8857 4 15.9516 33.2005 9.03859 1.48669 -13.8429 -11.0903 +8858 4 15.6081 34.5411 9.70154 -4.21994 3.45608 -1.0308 +8859 6 17.3638 40.6569 20.2187 0.0478101 13.797 12.0053 +8860 4 17.2553 39.7868 20.6094 -1.96745 -8.64858 -4.42208 +8861 4 17.5346 41.2369 20.9867 0.609446 0.00823871 -10.958 +8862 6 20.5168 9.71855 9.57392 23.3053 8.23996 -15.5036 +8863 4 21.1612 10.0129 10.2371 -5.46071 -1.58749 -5.90152 +8864 4 19.8092 9.36498 10.0856 -20.4585 -11.5711 12.7624 +8865 6 47.4431 20.1927 21.3797 46.3705 -23.5901 12.8176 +8866 4 48.2534 19.5912 21.2825 -32.1103 24.8918 7.30718 +8867 4 46.9863 20.0806 20.5604 -17.463 -0.0836882 -22.1962 +8868 6 38.4119 40.7863 37.8131 4.58972 -16.3007 -8.86139 +8869 4 38.2015 41.716 37.7675 -2.07213 19.1933 -0.538509 +8870 4 38.1163 40.4897 38.6817 -2.89344 0.451293 5.51523 +8871 6 4.78246 1.95264 13.1142 -0.962758 -11.3299 -4.56483 +8872 4 4.86308 1.24617 12.4504 1.09441 11.0888 1.2667 +8873 4 4.58181 1.48453 13.9266 -0.88642 0.622503 9.15822 +8874 6 46.8366 29.0044 2.17213 -21.5573 10.7483 2.0879 +8875 4 46.5703 29.0979 3.11526 14.9241 -10.138 -17.8178 +8876 4 47.6533 28.5191 2.04264 7.39387 -6.09514 13.7966 +8877 6 37.4332 26.1628 25.6457 0.476866 -1.57884 -3.35254 +8878 4 37.1432 25.5044 26.2761 -1.46501 -6.7424 3.65975 +8879 4 36.6379 26.5951 25.3475 -3.92424 6.80267 -0.609098 +8880 6 27.3215 4.19863 19.437 6.03131 -5.89417 1.59018 +8881 4 28.0693 4.5088 18.8685 -19.6633 0.0824503 4.70742 +8882 4 26.4692 4.57526 19.1444 8.48727 3.90116 -6.43998 +8883 6 29.5816 35.1763 32.6702 11.3433 -15.1984 -13.0035 +8884 4 29.498 34.4257 32.0309 -0.34209 19.1564 15.9908 +8885 4 30.487 35.489 32.5363 -2.16348 -1.10322 -0.755163 +8886 6 51.6039 27.3804 34.6228 -16.2846 20.7721 3.47149 +8887 4 51.9118 26.5342 34.8842 8.46829 -31.6815 14.0056 +8888 4 52.043 27.5552 33.7939 4.07896 7.882 -12.2594 +8889 6 26.213 15.718 22.6983 4.45652 -13.2698 4.19624 +8890 4 25.9644 16.5706 22.3629 -2.74203 26.12 0.0562263 +8891 4 25.9462 15.1046 22.0171 -4.99078 -11.3651 -6.14484 +8892 6 36.1284 41.1872 15.4686 -15.9675 5.34592 -0.326298 +8893 4 35.5872 40.4009 15.2728 11.0637 0.363161 -0.898578 +8894 4 37.0593 40.962 15.4319 4.98109 -12.2962 -3.97184 +8895 6 18.4605 8.81439 11.2163 9.85092 25.9028 -2.05591 +8896 4 18.8222 8.21565 11.8732 -2.65799 -9.87079 3.83174 +8897 4 17.6938 8.4288 10.8111 -9.58752 -11.4871 -1.05984 +8898 6 30.2054 21.3176 23.2008 0.0321998 2.06754 0.100272 +8899 4 29.9991 22.2239 22.9456 -2.76699 -3.99559 -1.97847 +8900 4 29.5697 20.7243 22.7648 2.21136 7.68347 0.454199 +8901 6 22.7376 2.20942 34.8415 -7.06988 -25.8748 21.345 +8902 4 22.3263 1.32441 34.7915 6.81547 13.2405 5.99888 +8903 4 22.6443 2.51876 33.959 0.748808 17.6695 -28.972 +8904 6 12.6779 2.74229 12.3423 -3.02369 13.9186 -14.8572 +8905 4 12.6684 3.63953 11.9163 1.20981 -22.4864 12.4813 +8906 4 13.1874 2.20366 11.7175 -0.841633 0.53426 4.77071 +8907 6 24.0891 30.0714 14.5767 2.26717 -13.4561 -11.586 +8908 4 23.8674 30.8343 15.1637 -15.8173 -12.4528 -15.4046 +8909 4 23.3482 29.6562 14.0436 11.1594 27.3113 22.4963 +8910 6 0.0169515 27.9037 22.8558 -22.9231 2.02358 -4.19556 +8911 4 54.5653 28.3586 23.5905 7.88497 -1.22395 1.09473 +8912 4 54.2173 27.7016 22.3138 13.4725 -1.40758 1.11908 +8913 6 12.3768 4.48401 25.8984 -1.01368 1.72138 -1.86924 +8914 4 11.999 5.34556 25.8124 1.61778 23.022 -11.6285 +8915 4 11.6412 4.07623 26.3496 -0.520107 -24.5543 7.98643 +8916 6 50.6552 14.4595 5.90563 -9.7075 2.6569 37.2621 +8917 4 51.421 15.0215 5.71422 1.2699 0.536098 -2.53407 +8918 4 50.4862 14.5526 6.9139 5.60038 -4.97296 -46.1729 +8919 6 52.566 22.8545 20.1304 -1.0263 1.56712 -17.1158 +8920 4 52.8493 23.3468 20.8979 1.30497 -0.175929 17.7779 +8921 4 52.7622 23.494 19.4302 -3.4332 -7.01119 -2.14697 +8922 6 43.5747 16.5432 12.8706 26.1082 -6.15301 -20.1459 +8923 4 44.3581 16.1075 12.4177 -27.2623 16.7463 17.9516 +8924 4 42.8105 16.3628 12.3102 -5.85283 0.59737 -2.51971 +8925 6 15.9643 16.7491 40.5889 4.71604 31.6512 -1.38133 +8926 4 16.4157 17.2981 39.8953 -10.7397 -16.8436 16.4649 +8927 4 15.6568 17.4119 41.253 8.12177 -13.8769 -14.2686 +8928 6 23.4093 18.8548 23.8539 -16.419 -4.21219 2.12821 +8929 4 23.4427 19.3457 24.6888 0.296298 -1.81048 -2.30579 +8930 4 22.5005 18.9913 23.5305 9.65682 -2.29273 2.24785 +8931 6 46.4286 3.27372 31.8783 1.50761 -1.36157 -5.63512 +8932 4 45.559 3.26328 31.468 -2.27736 -0.687336 -10.0334 +8933 4 46.2409 3.35124 32.8099 7.04458 2.11131 4.36323 +8934 6 43.404 41.0501 12.2894 -4.74196 -21.563 6.60959 +8935 4 43.6943 41.7945 12.8025 5.82787 10.392 6.16968 +8936 4 43.4921 41.2918 11.3656 -0.276957 5.00436 -10.4807 +8937 6 7.4944 32.479 29.5886 4.16519 42.7458 -9.72808 +8938 4 8.11522 31.7905 29.7504 15.4265 -22.4366 1.70525 +8939 4 8.06583 33.2868 29.4339 -18.9062 -19.2919 1.43274 +8940 6 4.77786 31.6555 22.5097 8.01353 -0.237295 6.09653 +8941 4 5.36252 32.2279 23.0433 -12.0801 1.27555 -9.50519 +8942 4 4.10079 32.1892 22.0697 5.55495 3.82082 5.5049 +8943 6 48.8707 26.8644 2.67473 3.24755 -50.1854 9.90243 +8944 4 49.7841 26.6767 3.05593 -33.5394 4.93648 -17.7122 +8945 4 48.3402 25.9967 2.74374 27.3415 43.0547 -3.91521 +8946 6 35.3704 23.2724 21.6151 -20.572 -8.60634 18.7236 +8947 4 36.1531 22.7653 21.8467 10.3528 0.763668 -1.9928 +8948 4 35.5272 23.8633 20.8878 14.153 10.3741 -19.8739 +8949 6 9.81162 37.7752 27.3066 -7.93747 -1.88745 -15.4111 +8950 4 9.56608 38.5967 27.7736 11.3364 -13.9943 4.65066 +8951 4 10.53 37.2723 27.7168 -2.00951 8.75096 9.6206 +8952 6 6.95784 10.9804 26.0002 -14.8513 -9.26658 -13.6642 +8953 4 6.43708 10.2284 25.6287 17.7452 16.2397 9.86134 +8954 4 7.32481 10.7062 26.8445 2.87033 -7.35616 11.341 +8955 6 15.9925 34.488 38.9165 -7.91378 13.4212 -4.2482 +8956 4 16.1125 33.5888 38.5756 -0.423195 -0.537141 7.5048 +8957 4 15.8451 34.497 39.8859 4.12272 -10.609 -16.5735 +8958 6 24.136 17.3087 36.1669 -1.30362 -38.1211 0.134245 +8959 4 24.6388 17.5417 36.9612 2.54889 -4.89456 5.81445 +8960 4 24.0565 16.298 36.169 6.29988 31.3296 1.89661 +8961 6 29.9661 19.0481 5.63552 -3.51045 -24.0694 26.081 +8962 4 30.059 18.4844 6.44318 1.40084 7.89656 -22.1005 +8963 4 29.4651 19.7932 5.9612 -6.50009 17.0844 0.645364 +8964 6 41.2323 14.2118 25.8708 0.538972 29.9242 -13.4546 +8965 4 41.1167 15.1135 25.4912 3.21098 -20.1981 4.76589 +8966 4 41.3237 14.3734 26.8138 2.01946 -2.10135 6.77926 +8967 6 30.5977 17.7991 37.3648 -2.09385 13.2702 -7.29075 +8968 4 30.1274 18.3693 36.6865 13.7219 -8.47854 26.2153 +8969 4 30.6897 18.2674 38.2325 -7.09621 1.58925 -18.9017 +8970 6 36.2622 35.7606 28.8616 -21.9344 -15.8478 13.9239 +8971 4 36.666 34.9659 29.2737 0.470987 14.2463 -5.72758 +8972 4 36.9609 36.34 28.5862 17.8584 7.52692 -3.58957 +8973 6 0.186361 37.881 20.3783 -19.4052 1.06805 -13.5296 +8974 4 0.625244 37.258 20.9754 1.43275 1.23053 -1.08677 +8975 4 54.3963 37.4077 20.0073 13.2242 8.68111 6.51083 +8976 6 49.5157 39.5849 25.2719 1.34086 -27.0873 28.6785 +8977 4 49.1738 39.8396 26.1677 9.83442 -4.23573 -27.15 +8978 4 49.8309 38.6394 25.3482 -11.1501 31.2987 0.525887 +8979 6 21.6501 10.2052 29.3652 1.38747 -32.8599 -17.8213 +8980 4 21.4815 11.1062 29.1158 -2.57329 19.5966 11.1399 +8981 4 21.7962 10.0736 30.3036 1.32123 13.0863 10.38 +8982 6 36.4484 30.062 0.133613 20.0221 49.2239 1.07318 +8983 4 36.3691 29.4748 41.3122 -8.72629 -28.1564 -18.1683 +8984 4 36.9877 30.812 41.6437 -16.8233 -22.5363 23.3328 +8985 6 35.2366 23.3806 39.1473 20.2218 -67.2813 -35.6269 +8986 4 34.8925 23.3776 38.2436 -2.85003 -5.00903 7.3464 +8987 4 34.9678 24.1769 39.4749 -24.7984 75.1446 29.9953 +8988 6 25.4958 17.6356 38.7131 -1.05403 5.23051 -13.5311 +8989 4 26.2557 17.1099 38.9745 11.6052 -6.82876 2.03202 +8990 4 25.6896 18.4914 39.1039 0.551448 5.55093 4.31103 +8991 6 32.6851 1.71412 15.3757 -17.1832 -26.0249 32.2484 +8992 4 32.9133 1.90091 16.3255 -0.281287 1.06348 -22.8896 +8993 4 32.1369 0.878474 15.451 14.5551 28.5253 -7.92953 +8994 6 2.74577 26.2334 40.164 -3.83079 -17.2464 -24.8373 +8995 4 2.52975 26.8073 40.8689 -10.0885 25.811 23.4985 +8996 4 3.46379 25.6906 40.4857 13.7859 -11.3271 -3.22577 +8997 6 25.4247 39.5803 6.65235 -3.20662 25.1889 -29.4644 +8998 4 26.0108 39.0547 7.19361 -10.0861 -10.9475 13.3666 +8999 4 24.4797 39.508 6.87242 11.3389 -11.2764 10.0712 +9000 6 3.89558 2.45526 21.1915 20.3615 -74.5786 -16.468 +9001 4 3.45835 1.54866 20.9342 19.9424 46.4596 11.9477 +9002 4 3.20863 3.06758 21.3193 -35.5841 29.5388 2.2294 +9003 6 19.428 35.9937 6.17834 -35.0483 8.79483 10.2733 +9004 4 18.6638 35.8781 6.77432 14.6839 -5.07873 0.0324743 +9005 4 19.0495 36.6291 5.56439 9.71061 8.85688 -10.7695 +9006 6 53.6717 10.8593 34.7958 -7.0633 -31.3632 -8.45381 +9007 4 53.6341 10.4895 35.6991 7.39736 18.8685 -12.2464 +9008 4 53.8829 11.7827 34.7263 4.03482 19.5096 16.0301 +9009 6 51.2684 14.0949 34.672 -8.65676 -1.63762 -26.9588 +9010 4 50.7715 13.5641 33.9816 13.3581 12.906 22.4054 +9011 4 51.0369 13.7812 35.5532 -5.90867 -9.66849 3.74112 +9012 6 14.4369 40.0234 28.032 -17.7583 12.3896 33.8878 +9013 4 13.8707 39.2432 27.9284 6.73847 -3.79593 -5.43806 +9014 4 14.0697 40.4885 28.8439 14.5888 -10.3946 -25.5694 +9015 6 36.0586 40.8581 1.30985 34.3129 5.11816 -1.28261 +9016 4 35.3876 41.022 1.96214 -5.4524 5.11716 12.4526 +9017 4 36.8901 41.3246 1.61712 -30.5352 -10.0787 -2.88322 +9018 6 32.5955 21.8673 9.61487 11.2903 3.47268 22.8686 +9019 4 32.2562 21.1899 9.03409 -3.19899 -6.31213 -16.1683 +9020 4 32.8032 22.6511 9.09762 -2.66985 0.307575 -11.8305 +9021 6 53.7554 11.4583 10.0657 12.5408 -15.0223 -21.3323 +9022 4 54.7025 11.5478 10.261 -4.15933 2.55001 3.12883 +9023 4 53.7605 10.7769 9.36125 -9.51558 7.63224 9.70748 +9024 6 25.4365 2.06658 35.0039 -16.8474 18.4627 -14.151 +9025 4 25.5892 2.94197 34.5728 -1.09755 -16.5277 9.12484 +9026 4 24.4603 2.05675 35.1439 15.8828 -2.54758 -2.86629 +9027 6 38.4258 16.3759 27.0837 10.3035 -3.82582 33.4754 +9028 4 38.4229 16.0362 28.0039 4.2105 -6.34073 -14.2668 +9029 4 38.1536 17.2766 27.2341 -1.96409 14.1736 -9.55492 +9030 6 11.9898 11.8134 38.076 -13.826 -2.82892 7.4824 +9031 4 12.2944 12.4411 38.7385 15.2198 2.85174 -2.31876 +9032 4 11.0532 11.721 38.3132 2.05768 -5.32701 -10.6008 +9033 6 21.1746 40.7334 25.8979 40.4357 -13.6237 -24.6728 +9034 4 20.6698 41.4315 25.4918 -16.6357 14.348 -0.996217 +9035 4 20.789 40.494 26.7242 -19.3448 -1.94923 24.9485 +9036 6 5.46053 31.2633 28.1043 10.2831 7.82506 0.3012 +9037 4 4.85681 31.7249 27.5011 4.53193 2.9664 -2.03256 +9038 4 6.18919 31.875 28.3487 -9.19227 -4.78386 -2.03476 +9039 6 38.5722 10.4288 26.6273 1.75688 -6.42268 2.69181 +9040 4 39.2722 10.957 26.2192 0.13713 -2.38088 1.965 +9041 4 38.9883 9.93745 27.351 -0.726559 6.62326 -4.692 +9042 6 34.5654 22.2334 5.77474 -10.6824 6.04198 20.2303 +9043 4 33.6505 22.4646 6.03122 6.34024 -5.77168 -8.80249 +9044 4 35.1097 22.5906 6.49609 1.67963 -6.25138 -9.01327 +9045 6 19.5088 23.4111 8.91157 10.1707 -16.3121 14.7533 +9046 4 19.7449 23.1021 9.7973 -5.16612 6.6008 -0.0119594 +9047 4 19.9964 22.8054 8.35541 -0.106246 2.40248 -11.9056 +9048 6 19.7526 39.1673 18.9392 3.41392 2.41259 -7.44399 +9049 4 20.3112 38.9942 19.7162 -9.66179 4.90282 -1.08801 +9050 4 18.9888 39.695 19.2431 8.6955 -6.10904 -0.220035 +9051 6 19.0066 16.6479 37.8897 24.9266 -16.0788 2.00499 +9052 4 18.1904 16.5622 37.4269 -20.8911 -0.0800444 -12.5516 +9053 4 18.858 17.3198 38.5387 -2.83386 13.0664 11.2213 +9054 6 46.1457 18.3015 34.4662 -13.7163 3.02283 10.6817 +9055 4 46.1788 17.7584 33.6837 2.50627 -7.36872 -12.652 +9056 4 45.2295 18.6352 34.4793 7.83367 -3.11582 0.242547 +9057 6 37.6724 4.92727 10.6572 20.6306 -0.498941 -29.5329 +9058 4 38.5268 5.23995 10.2493 -20.9001 -6.48587 16.5696 +9059 4 37.1025 4.69637 9.88262 10.9132 7.05613 26.3995 +9060 6 51.9879 36.0003 6.84307 -0.0349375 1.28893 10.7684 +9061 4 52.0937 36.793 6.30051 2.19835 -5.62517 4.5242 +9062 4 52.7425 36.0295 7.48232 -7.26034 2.01661 -20.7899 +9063 6 26.6747 12.3215 0.993928 -15.5873 -26.456 -19.7503 +9064 4 26.4829 12.3908 1.92985 -0.4811 3.80705 11.7504 +9065 4 26.1241 11.5295 0.732228 15.7893 19.669 4.48242 +9066 6 51.344 35.7707 13.5244 -1.45768 15.8539 -2.86245 +9067 4 51.4515 36.3837 12.7824 1.55721 2.40741 1.90229 +9068 4 51.4783 34.9191 13.1366 6.57206 -21.9808 -6.55402 +9069 6 1.98876 3.63996 24.5779 3.53339 50.093 -23.5227 +9070 4 1.66274 3.05681 25.2088 -14.7773 -39.8355 33.4132 +9071 4 1.68527 4.50485 24.9411 8.95614 -12.6616 -11.2736 +9072 6 33.5242 15.2767 16.4494 0.0755523 4.59339 -41.038 +9073 4 33.5553 15.5138 15.4787 -3.36737 -9.15609 28.4742 +9074 4 33.81 16.089 16.8707 2.78154 5.67933 12.8052 +9075 6 10.7376 26.5972 37.3568 -53.543 46.6204 -3.13137 +9076 4 10.2745 27.0143 38.1249 4.48347 -4.84659 -12.5134 +9077 4 11.4659 26.2171 37.7527 59.8403 -33.1666 26.4091 +9078 6 39.618 8.36935 32.0025 -18.1555 9.41152 20.5333 +9079 4 39.1948 8.91554 32.6893 14.8148 -9.04413 -3.7523 +9080 4 39.059 8.55692 31.2545 -3.75745 -0.899113 -17.0741 +9081 6 48.8678 24.2325 11.5968 8.56011 -30.9839 -7.0275 +9082 4 49.2355 23.3258 11.4382 -10.5357 21.2684 5.64902 +9083 4 49.6052 24.6956 12.0119 -1.11745 3.30341 0.0123828 +9084 6 15.7966 8.52145 22.5402 1.04041 9.04678 1.57429 +9085 4 15.9271 8.56462 21.5825 -0.708828 -3.15413 5.43528 +9086 4 15.5351 9.42629 22.7739 -0.982858 -3.13072 -0.606507 +9087 6 16.9647 23.5461 7.94634 -33.4976 4.63454 -7.56842 +9088 4 17.0449 23.8842 7.03772 17.2153 -3.19264 11.7182 +9089 4 17.7681 23.4723 8.45101 25.4501 5.7081 -7.03081 +9090 6 42.4788 26.856 6.32162 3.09129 16.6976 -8.96027 +9091 4 41.8509 27.5547 6.55233 4.05081 -5.7053 1.31186 +9092 4 43.1337 27.3683 5.79469 -5.76138 -9.42264 4.17624 +9093 6 36.7899 4.80361 30.039 -6.11534 9.52442 2.68488 +9094 4 37.0233 4.89717 30.9689 4.03122 4.23205 -0.240484 +9095 4 36.2783 4.00567 29.9694 -7.15291 -10.8132 -0.980928 +9096 6 45.6188 11.6101 3.31184 17.0103 13.4398 12.4748 +9097 4 45.8378 10.6807 3.43524 1.11174 -8.0511 2.33471 +9098 4 46.2756 12.0957 3.86714 -12.3909 -9.3108 -12.4209 +9099 6 24.8953 36.3829 21.2888 -10.2051 -4.79955 -3.81503 +9100 4 24.4947 36.4635 22.1668 10.8854 5.06826 1.45383 +9101 4 25.816 36.6689 21.3407 0.621807 2.11968 6.76072 +9102 6 31.8152 24.7333 2.44905 16.2387 18.0677 -0.666362 +9103 4 31.5926 23.846 2.71622 -2.49338 -12.6998 4.18613 +9104 4 32.794 24.7683 2.43834 -16.3068 -2.39725 -1.0987 +9105 6 24.1315 21.9864 37.2328 -11.9778 41.7246 15.7453 +9106 4 24.1531 22.9879 37.1682 1.73438 -35.6656 2.36813 +9107 4 24.6319 21.6756 36.4808 8.45953 -1.72708 -12.6617 +9108 6 37.1993 11.5451 15.0492 16.5469 7.10484 -0.527568 +9109 4 37.9299 11.7412 15.6355 19.6925 -10.3737 -3.43176 +9110 4 36.5282 11.9944 15.5291 -36.4248 10.8574 4.75341 +9111 6 36.4804 20.3298 41.7865 -14.7619 -38.0306 11.4639 +9112 4 36.2972 19.4996 41.306 -2.7681 3.32899 7.9346 +9113 4 36.9128 20.8369 41.1399 19.1888 26.5648 -23.5244 +9114 6 32.0378 37.9251 32.6621 -20.5074 -27.3147 -8.21436 +9115 4 32.5159 38.6908 32.9558 4.48721 20.2349 -0.22713 +9116 4 31.3298 38.1855 32.0457 8.6638 5.37323 8.26506 +9117 6 12.0353 39.9275 22.5179 -19.9222 21.97 13.043 +9118 4 12.3148 40.8142 22.1582 -9.65836 -22.9721 12.3921 +9119 4 11.2968 40.0749 23.1753 26.4497 -1.81786 -22.4595 +9120 6 26.3421 1.33641 19.2861 18.8224 -12.0939 15.9617 +9121 4 26.8564 0.711595 19.8557 -14.3211 16.2919 -14.6989 +9122 4 26.7977 2.18849 19.3545 -2.53714 -0.144297 -3.51109 +9123 6 5.91333 14.3058 5.68279 5.58536 -17.6781 -26.1831 +9124 4 6.35226 14.1008 4.80839 -10.2521 5.5819 21.3359 +9125 4 5.1498 13.7016 5.72209 7.95548 1.62414 0.442017 +9126 6 13.3681 23.0924 19.1542 -7.87238 10.4677 13.234 +9127 4 14.1204 22.8148 18.6592 15.6827 -8.39443 -13.4152 +9128 4 13.7622 23.5769 19.9007 -5.90355 -3.89356 -3.96922 +9129 6 23.3981 15.0775 9.7431 -16.2896 3.15659 0.0853289 +9130 4 22.5416 14.6758 9.94236 4.38356 -3.66538 1.71341 +9131 4 23.1926 15.7004 9.03099 5.43777 4.93098 -2.67512 +9132 6 49.5886 13.8369 18.4468 -1.57371 0.160736 10.1606 +9133 4 48.8725 13.4353 17.9701 -17.3578 -11.6866 0.338485 +9134 4 50.0711 14.2256 17.7358 20.2332 17.1818 -14.445 +9135 6 41.7455 5.66741 41.8995 19.0031 1.14603 7.86728 +9136 4 42.5946 5.93333 0.438032 -19.5636 -6.95293 -12.6597 +9137 4 41.9891 5.05837 41.1762 -2.65724 5.24908 4.18535 +9138 6 17.2511 35.5417 2.55548 5.2045 0.397579 1.12894 +9139 4 18.2067 35.619 2.48098 6.39755 9.05508 3.07921 +9140 4 17.0886 34.6316 2.34229 -4.27489 -11.2961 -3.02567 +9141 6 49.7041 19.8589 40.2412 43.8428 -27.8149 3.09893 +9142 4 49.318 19.0163 40.5437 -5.31641 8.5833 -2.14336 +9143 4 50.6864 19.6533 40.2493 -27.6084 12.6334 -3.24012 +9144 6 38.3071 5.82731 32.0534 -20.9946 -3.84451 12.3853 +9145 4 37.8352 6.48986 32.6009 6.6943 -7.79079 -6.23381 +9146 4 39.2094 6.1245 32.003 13.4939 6.60324 0.292563 +9147 6 16.2694 6.84865 34.0054 -5.49782 1.82896 8.85162 +9148 4 16.5828 6.71308 33.1028 9.77351 -3.29618 -0.21352 +9149 4 16.9894 6.61948 34.6288 -2.86373 0.259786 -9.19674 +9150 6 33.6805 18.2019 10.4544 40.2358 -26.4835 -11.4715 +9151 4 34.2537 18.8203 9.96489 -9.74865 -7.15313 7.53482 +9152 4 34.2179 17.3378 10.5117 -27.819 38.8859 -1.78852 +9153 6 38.8962 33.7675 36.7566 23.6769 3.34821 -39.6603 +9154 4 38.383 33.5793 35.9171 9.63189 4.7017 21.543 +9155 4 39.855 33.8637 36.4612 -29.1237 -5.01255 9.39617 +9156 6 45.367 13.0954 20.2202 -17.4715 7.54819 27.7127 +9157 4 45.262 12.6289 19.4029 4.78427 -8.6457 -19.3619 +9158 4 44.4728 13.0498 20.6095 8.33403 2.77458 -3.46579 +9159 6 36.394 32.2025 8.83838 -5.39961 -0.779561 10.8196 +9160 4 36.3766 31.4559 9.45045 4.37642 -0.919546 -0.394048 +9161 4 35.9671 32.9207 9.33542 2.20851 -0.984819 -7.57369 +9162 6 7.93081 27.8143 6.16526 -1.31132 8.47671 -18.7581 +9163 4 8.2701 27.2941 6.88743 5.87236 -5.84072 6.56369 +9164 4 8.18271 28.7096 6.41539 -7.71007 1.94397 -1.55613 +9165 6 14.2797 4.87717 33.6823 -38.1616 11.9775 -32.0892 +9166 4 13.6477 5.2447 32.9846 23.9092 -16.4836 27.177 +9167 4 14.8408 5.63056 33.8658 12.4601 7.15131 6.13949 +9168 6 12.2578 8.65243 9.85848 -4.82715 -2.24662 -5.48477 +9169 4 12.6456 8.73928 10.7118 23.7259 9.48722 19.5525 +9170 4 11.4378 8.2214 10.089 -13.622 -8.47682 -13.9839 +9171 6 29.7261 31.9842 8.54243 -17.2145 25.3825 -18.7463 +9172 4 30.1804 31.833 9.34913 11.7892 -12.8324 21.9258 +9173 4 29.6399 31.1708 8.03663 5.85846 -6.51984 4.51241 +9174 6 22.3891 10.8785 21.4662 8.73739 -5.18702 6.55753 +9175 4 21.8037 11.1386 20.7714 -14.2177 0.338512 -24.4291 +9176 4 22.2091 11.5521 22.1168 2.36988 5.22793 14.1218 +9177 6 54.1797 27.5396 12.9955 26.3988 -18.3584 17.6139 +9178 4 0.160041 27.5787 13.0909 -6.71045 -5.06664 4.99497 +9179 4 53.9798 28.2721 12.4475 -15.7222 27.4826 -22.0497 +9180 6 7.71973 13.812 20.0407 -34.9077 17.0186 -30.9147 +9181 4 8.32362 14.1503 20.6766 20.1403 8.526 22.156 +9182 4 7.35968 14.6399 19.6101 8.73645 -26.5601 8.16532 +9183 6 19.7932 0.841243 24.7869 -1.21084 18.2021 12.2367 +9184 4 19.1669 1.06895 25.5104 7.86649 -0.445713 -11.3386 +9185 4 20.4073 1.61074 24.7031 -15.4775 -18.2332 3.4978 +9186 6 3.01312 10.0986 2.94829 -27.2997 12.089 -8.88269 +9187 4 2.52802 10.9508 2.83041 12.1807 -20.5661 3.67701 +9188 4 3.91304 10.3154 3.17839 17.025 6.36995 4.07131 +9189 6 15.8857 13.0124 24.0049 15.5529 -4.67501 -5.43243 +9190 4 15.0856 13.5308 24.0834 -5.13718 6.9751 3.63726 +9191 4 16.3233 13.139 24.8614 0.105722 -2.17465 -3.852 +9192 6 17.0852 4.33969 26.9167 21.5143 -4.09641 1.48348 +9193 4 16.9912 4.27513 25.9666 -0.355278 1.74978 -10.9716 +9194 4 18.0601 4.31538 27.0472 -16.9044 3.21714 1.83131 +9195 6 33.6168 39.4091 10.6433 -2.74936 14.5855 -32.8438 +9196 4 33.9454 38.5625 10.8616 8.60753 -33.4012 17.9817 +9197 4 33.8375 39.4354 9.68976 -8.01757 16.2593 11.171 +9198 6 36.2326 1.10755 13.0941 -10.1125 -3.31802 -5.56412 +9199 4 35.6506 0.392496 13.3579 -10.7819 -8.26966 -9.36682 +9200 4 36.7599 1.20112 13.8707 17.1874 9.72194 12.3054 +9201 6 40.862 19.2925 5.11158 -0.402197 -15.9333 44.5432 +9202 4 40.3871 19.4968 4.34679 -15.032 12.6888 -52.1674 +9203 4 40.1189 19.1611 5.72143 13.4548 0.976419 10.4775 +9204 6 2.35452 37.5497 10.1778 32.5589 0.132829 19.8916 +9205 4 3.04634 37.0953 10.7141 -10.4583 9.64478 -9.40166 +9206 4 1.85979 36.8581 9.75685 -15.4906 -16.9123 -13.0897 +9207 6 8.10293 29.0334 15.8847 29.3895 -23.7333 0.542295 +9208 4 9.03551 28.6824 15.7668 -29.6945 17.5799 0.572456 +9209 4 8.18484 29.8326 16.4072 3.85606 5.10463 3.42896 +9210 6 47.3132 26.514 12.5427 4.56821 28.1849 -37.0073 +9211 4 47.5111 27.2634 11.8891 -8.56493 -28.9528 31.2783 +9212 4 47.3519 25.7475 11.9556 -1.34676 -3.33794 4.54904 +9213 6 33.5886 17.4994 0.666432 -7.15301 -2.01744 8.51284 +9214 4 32.6196 17.5968 0.930917 31.8637 -19.8727 -7.43903 +9215 4 33.9404 16.5735 0.747207 -21.2256 15.6146 2.50609 +9216 6 38.9757 15.6004 36.3686 4.31005 -11.6982 -11.4703 +9217 4 39.1719 14.652 36.4294 -3.02079 4.3409 1.02949 +9218 4 39.3764 15.8813 35.5317 -1.53099 5.14915 -0.246696 +9219 6 34.8198 34.351 9.37266 2.46578 -22.7668 -16.8875 +9220 4 35.3506 35.0289 8.96724 14.9634 11.0695 -15.2613 +9221 4 34.4558 34.8191 10.0913 -19.5236 18.4179 34.8179 +9222 6 44.9681 2.58102 14.7874 21.8703 21.498 2.75759 +9223 4 44.0383 2.44896 14.9383 -16.9502 -5.72583 1.77575 +9224 4 45.1679 3.47323 15.1264 -3.49788 -5.23458 -3.46791 +9225 6 42.6138 38.2902 19.8325 18.6047 12.1973 -29.2276 +9226 4 42.7029 39.1598 19.3445 -0.0117609 -27.8329 13.7468 +9227 4 43.0921 37.6383 19.2425 -13.1736 20.1758 17.0781 +9228 6 18.6869 26.7647 30.2619 -33.6624 -6.012 -17.6355 +9229 4 18.1258 26.7596 29.445 14.3051 -0.674317 21.614 +9230 4 19.5687 26.9499 29.9621 19.5047 4.84041 -5.57389 +9231 6 38.8661 37.7421 16.4836 -9.78438 -6.51051 7.80135 +9232 4 38.7478 36.8102 16.2377 -7.01003 6.44463 1.75037 +9233 4 39.8105 37.8446 16.5724 18.1337 5.4462 2.51551 +9234 6 49.3017 9.82081 12.5377 12.9664 18.8416 30.0962 +9235 4 48.8085 9.39111 11.8826 -17.6666 -23.7062 -38.8329 +9236 4 48.5984 10.2345 13.0427 4.42646 9.01279 7.79627 +9237 6 43.2246 7.36268 19.8264 -1.99344 11.167 24.993 +9238 4 42.5572 7.81175 20.4051 12.7818 -10.9207 -14.0727 +9239 4 44.1025 7.51179 20.2375 -5.96789 -3.6213 -7.06723 +9240 6 36.3461 38.714 4.42821 -2.77728 9.11116 8.98737 +9241 4 36.8002 39.5234 4.70824 5.05063 -6.10698 -1.49424 +9242 4 35.4394 38.9016 4.68929 -3.84434 -7.68842 -3.54296 +9243 6 27.8 17.802 15.105 0.992317 -7.44098 -8.78046 +9244 4 27.5393 16.935 14.729 3.58787 16.6938 2.50389 +9245 4 27.8517 17.6781 16.0585 0.147204 -0.130556 3.13955 +9246 6 18.0837 3.77506 37.3201 -10.3169 -12.5791 -10.2966 +9247 4 18.6663 3.07474 37.0146 -2.03685 -5.25132 -4.70316 +9248 4 18.6637 4.19691 37.9324 10.4473 20.1285 21.3871 +9249 6 7.71395 11.575 6.52222 6.59834 -21.2687 20.1659 +9250 4 7.75955 12.4254 6.93969 -0.705235 13.257 9.50392 +9251 4 7.66936 11.739 5.5978 -3.42683 1.36071 -31.338 +9252 6 31.4909 14.3449 18.0451 -1.46982 -12.276 17.176 +9253 4 32.1287 14.6507 17.397 7.38292 5.65775 -7.44504 +9254 4 32.0331 13.8785 18.7146 -6.90734 4.25576 -5.30331 +9255 6 50.3346 30.4143 8.91505 10.1635 2.25064 -1.90936 +9256 4 49.6557 30.853 8.39615 -4.47176 4.28708 -1.87566 +9257 4 50.0231 29.531 9.11356 -2.73977 -1.84009 2.34474 +9258 6 42.1686 10.1057 12.759 16.2008 2.03437 -4.20809 +9259 4 41.2649 9.83209 12.6487 -17.4225 -8.81494 -4.74081 +9260 4 42.1292 10.8861 13.3105 -1.28453 5.18814 5.66853 +9261 6 37.773 3.09539 32.5582 -5.24906 4.78867 -2.39206 +9262 4 38.0736 3.99724 32.5969 21.7942 11.3719 -4.3192 +9263 4 36.8519 3.25822 32.7463 -19.4678 -11.9252 3.55114 +9264 6 35.7586 13.1005 19.2721 9.99017 -22.7528 0.0781354 +9265 4 36.1308 13.8223 19.7887 2.26592 2.2719 5.61144 +9266 4 36.2509 12.2915 19.5517 -9.66412 15.3645 -2.5809 +9267 6 45.5318 4.12684 21.4944 7.1153 -16.224 0.922187 +9268 4 45.5588 4.23252 20.5315 -1.8039 6.94223 3.67507 +9269 4 45.7548 3.18328 21.6122 -5.15542 13.2346 -0.821742 +9270 6 16.876 1.8608 31.4782 -3.84426 -17.9183 -35.0426 +9271 4 16.0621 2.17388 31.0004 15.6258 0.929179 27.3362 +9272 4 17.1381 2.25043 32.3174 -12.6393 14.1325 4.42374 +9273 6 14.0947 4.88307 23.5769 -10.6061 -28.6131 16.0669 +9274 4 13.8059 5.76888 23.7237 -2.25817 32.588 -6.82267 +9275 4 13.6039 4.42137 24.2892 9.04813 -2.88937 -11.9208 +9276 6 38.3208 33.7635 12.3625 -16.3318 -7.70706 -26.0192 +9277 4 38.1373 32.9408 11.8506 0.297782 14.7405 12.2413 +9278 4 39.1486 33.6221 12.8093 16.0136 -1.39994 11.7584 +9279 6 35.6849 3.05753 37.6719 3.72695 1.1389 -16.7638 +9280 4 35.1101 2.5063 38.212 -4.0587 0.687226 6.19097 +9281 4 35.8854 3.87289 38.1447 -1.86413 5.08658 8.8135 +9282 6 31.3385 37.395 35.3723 -12.2239 -8.91609 34.0312 +9283 4 32.2231 37.7249 35.5382 9.93962 6.70229 -3.55138 +9284 4 31.225 37.4524 34.4409 4.86335 0.993516 -31.3389 +9285 6 52.0614 11.7324 14.0182 20.1458 -4.7001 -39.6215 +9286 4 52.0268 11.0667 13.2735 0.495691 14.4049 24.809 +9287 4 52.7095 12.4171 13.7023 -24.8081 -17.2766 13.6147 +9288 6 26.3478 3.42613 41.0189 1.80794 1.58056 -19.374 +9289 4 25.6151 4.01507 40.9203 -25.7718 5.99951 16.8165 +9290 4 26.7914 3.68675 40.2055 22.5797 -12.3384 -0.204994 +9291 6 24.3802 34.9453 11.1613 28.8325 38.7039 -6.19962 +9292 4 24.3515 34.6784 12.0652 -4.50215 -14.1529 28.2178 +9293 4 23.9023 34.3202 10.6558 -20.492 -31.6724 -14.1682 +9294 6 32.0094 7.59293 31.2147 -3.26399 8.81733 5.62682 +9295 4 32.0976 7.47613 30.2777 2.1706 -0.778595 -17.1478 +9296 4 31.5266 8.43606 31.2858 0.565291 -7.84955 4.65821 +9297 6 28.7282 2.60805 0.424377 -15.1279 1.50585 -5.39222 +9298 4 29.2952 2.36387 41.5859 -5.33248 3.35197 5.42737 +9299 4 27.7901 2.65331 0.119401 23.4632 0.0509354 2.06419 +9300 6 42.125 19.2126 9.86039 10.7783 -7.26578 33.4177 +9301 4 42.6695 19.2101 10.7019 -20.1092 0.869002 -30.5597 +9302 4 41.4363 18.5278 9.96356 3.48727 6.10561 -4.25932 +9303 6 33.0194 27.0842 8.32851 16.6372 -6.55357 -10.7525 +9304 4 33.8911 27.0001 7.90493 -7.38323 -0.765342 -2.5624 +9305 4 33.2437 27.3744 9.20899 -0.425855 7.33259 11.2137 +9306 6 4.16433 8.30018 19.1575 16.0783 -2.51395 5.95143 +9307 4 4.71165 7.98099 18.3991 -19.3854 5.29846 8.38252 +9308 4 3.22273 8.32359 18.9288 3.05712 -5.28108 -12.2975 +9309 6 20.7745 29.1912 37.0609 -25.9123 -20.3491 -5.83769 +9310 4 21.0713 28.277 37.0594 -15.1664 -12.7508 0.5123 +9311 4 21.6013 29.5933 37.1743 32.957 35.4267 8.73191 +9312 6 13.1089 4.99809 10.9103 2.80775 13.1965 -7.17841 +9313 4 13.4591 5.85092 11.2415 -2.5949 -14.1267 -1.88178 +9314 4 12.7051 5.16456 10.0462 -1.2434 3.82389 2.90473 +9315 6 37.5087 18.1031 32.5343 20.0502 31.699 14.1692 +9316 4 38.1018 18.8164 32.1735 -18.2411 -21.7333 4.56216 +9317 4 37.2041 18.4813 33.3903 1.90105 -7.17599 -12.7275 +9318 6 17.7655 33.2839 30.7231 12.9967 19.9173 -17.9311 +9319 4 17.8488 34.0437 30.1253 -3.68331 -4.50715 1.49576 +9320 4 18.5638 33.345 31.2563 4.57995 -0.934488 4.72964 +9321 6 23.1969 32.7832 9.90135 2.14033 10.4984 -5.43395 +9322 4 23.4737 31.9362 10.2634 3.28964 -4.66398 1.33779 +9323 4 22.2469 32.7196 9.72631 0.753558 0.42269 -0.434072 +9324 6 14.8911 9.35828 34.246 -8.54616 0.784134 0.501674 +9325 4 15.4672 8.59016 34.1372 5.2294 -0.0873347 -3.8795 +9326 4 15.23 10.0905 33.7027 2.53244 -1.05206 0.202563 +9327 6 31.1203 39.3599 38.5719 4.30147 -17.578 8.21172 +9328 4 31.5941 38.6377 39.0527 -10.1026 17.4492 -9.05875 +9329 4 30.4019 38.9077 38.1077 1.84332 2.82409 1.03593 +9330 6 5.29005 34.4279 28.2716 -0.764315 -10.945 -9.90403 +9331 4 5.24266 35.3772 28.447 -0.427568 -2.02335 -2.15628 +9332 4 5.18384 34.3192 27.3143 2.05225 4.04935 9.99949 +9333 6 30.3216 21.6974 14.1256 3.24994 1.03129 -0.468005 +9334 4 30.4656 20.7696 14.235 0.884625 -14.9253 16.053 +9335 4 30.3519 21.7638 13.1772 -0.963709 16.3006 -15.7103 +9336 6 23.8542 39.0018 28.2919 38.6077 23.8437 -8.99828 +9337 4 23.8505 39.6937 27.6143 9.44649 3.56781 3.51793 +9338 4 23.0185 38.6309 28.1896 -50.029 -28.3524 0.952356 +9339 6 9.61332 13.5451 16.4567 13.7131 10.5156 -25.323 +9340 4 8.77595 13.0917 16.3907 -9.93448 -5.52821 8.41851 +9341 4 9.74204 13.8378 15.5322 5.69689 -3.544 12.5309 +9342 6 25.9753 6.18174 15.7989 23.4837 -9.67411 23.9067 +9343 4 26.0218 6.10484 14.8454 5.11216 -1.95092 -7.71856 +9344 4 26.7445 5.66727 16.1761 -27.6477 18.1551 -17.3833 +9345 6 15.9921 33.6419 22.5616 2.25497 8.86036 -26.9911 +9346 4 16.0049 34.0594 21.6804 -4.22455 0.568633 15.0409 +9347 4 16.1032 32.7157 22.281 -1.05219 8.42244 16.6761 +9348 6 40.6812 13.5416 12.1266 -4.5396 -12.3661 6.74099 +9349 4 40.4134 12.947 11.4149 -4.75912 -2.4644 -8.17888 +9350 4 41.058 12.9332 12.7776 -0.386087 8.79442 1.8157 +9351 6 35.5875 40.2809 31.6993 12.2791 -13.6127 -29.8257 +9352 4 35.948 40.913 31.0681 -4.17713 12.2213 7.17402 +9353 4 35.6271 39.4709 31.1475 -9.59473 3.36029 20.1077 +9354 6 19.3493 17.5927 17.849 24.123 48.8902 3.26857 +9355 4 19.9577 18.423 17.9915 -34.5112 -38.8316 -9.06029 +9356 4 18.6928 17.806 17.1645 6.15508 1.01267 5.31501 +9357 6 7.96541 28.082 10.7737 20.0283 17.3944 8.50509 +9358 4 8.43659 28.8341 11.2297 -13.1431 -15.7733 -11.3814 +9359 4 7.20109 28.4458 10.3015 -0.215648 4.06143 0.688545 +9360 6 32.1489 39.5869 16.6475 -7.37335 1.81146 -4.92627 +9361 4 31.705 40.4043 16.3332 3.90743 -15.5774 4.53996 +9362 4 31.4977 38.8659 16.5723 3.01217 10.596 3.08762 +9363 6 35.8095 2.63602 18.127 2.07542 -14.8225 4.13142 +9364 4 34.8947 2.32962 18.1713 7.15775 -3.6283 3.09768 +9365 4 35.7135 3.4873 17.7367 2.81673 20.5762 -11.5045 +9366 6 14.9588 39.9585 36.8943 -2.86001 -28.3727 24.0409 +9367 4 15.4545 39.4909 36.2335 10.0689 -8.68258 -13.459 +9368 4 15.0094 40.8569 36.655 2.72867 44.443 -9.08423 +9369 6 18.3115 32.3916 11.4639 8.59274 12.4423 14.7113 +9370 4 18.6438 32.5881 12.3772 -9.2478 -5.5834 -23.9484 +9371 4 17.8762 33.212 11.1576 6.35145 -13.5457 0.164794 +9372 6 14.605 10.3819 4.99774 5.57597 -6.68493 12.6773 +9373 4 13.677 10.4388 4.75284 -6.10435 1.24571 -3.75468 +9374 4 14.6185 10.047 5.91478 4.2493 4.0336 -10.9734 +9375 6 2.02851 14.3408 39.1627 -4.03313 12.5981 -1.48522 +9376 4 2.74992 15.009 39.2086 -14.5088 -8.45155 5.07373 +9377 4 1.21458 14.679 39.6124 19.1623 -3.42757 -8.41789 +9378 6 7.58709 14.1522 32.4651 10.4977 19.6861 -0.504887 +9379 4 6.93593 13.6605 32.9674 -3.57672 2.30039 3.8359 +9380 4 7.5987 15.0834 32.797 -1.90079 -22.9019 -5.87851 +9381 6 6.15309 23.123 37.664 -26.7168 -14.8188 -11.2926 +9382 4 6.52639 23.9838 37.7378 17.5333 20.6862 9.20416 +9383 4 5.45539 23.2608 36.9958 8.40974 -10.7335 8.81374 +9384 6 37.3009 22.5422 4.44282 21.6187 66.9857 0.670839 +9385 4 36.5208 22.1217 4.15693 -30.5217 -23.5005 -12.8181 +9386 4 37.1232 23.5227 4.23696 10.5274 -41.8214 11.62 +9387 6 47.1349 31.0113 5.88613 -14.3653 5.64202 -58.02 +9388 4 46.9542 30.9019 6.7933 -9.29323 -2.10558 39.1512 +9389 4 46.2627 31.2059 5.44524 20.5013 -7.22248 10.5418 +9390 6 54.8094 25.5909 34.9286 -5.37395 41.5808 12.672 +9391 4 54.0266 25.5089 35.4943 -0.981006 -11.4098 -6.26775 +9392 4 0.0616925 26.543 35.1263 -1.5494 -32.4448 -11.2369 +9393 6 37.1551 2.08197 4.79239 -12.5712 23.0197 -22.5278 +9394 4 36.5844 2.86136 4.61445 9.59981 -14.8952 -2.62483 +9395 4 37.0798 1.96202 5.72873 2.5296 -7.23911 19.6989 +9396 6 22.5239 28.6012 8.91155 -7.98869 19.6075 21.4366 +9397 4 22.8946 28.4124 9.79991 -0.853296 -5.89568 -17.4096 +9398 4 22.801 27.9767 8.25343 10.1708 -14.6558 -3.7409 +9399 6 8.64208 27.1509 24.5664 -38.2161 25.5543 4.78276 +9400 4 7.71753 26.8887 24.5582 -5.16372 11.0804 -0.386298 +9401 4 9.04357 26.3309 24.4724 40.7169 -47.477 -5.23592 +9402 6 1.14997 23.727 2.4309 6.46058 8.65979 -14.8341 +9403 4 1.18232 23.9936 1.48373 -6.63581 -4.99587 16.5657 +9404 4 0.310199 23.2733 2.54924 -0.981545 -0.950126 -1.89037 +9405 6 54.3702 30.2259 27.0243 -0.035121 6.58363 -4.50453 +9406 4 54.2615 29.4654 26.4339 1.23903 8.74071 -4.24792 +9407 4 54.6064 30.9974 26.4582 -3.83852 -12.4126 5.30421 +9408 6 0.386829 8.42023 23.9938 5.00922 -16.8445 -6.80376 +9409 4 1.36083 8.4508 24.0758 -8.17173 1.21512 3.08891 +9410 4 54.9524 8.88826 24.7258 9.13745 3.54566 6.13736 +9411 6 16.8971 28.5839 33.3722 23.8511 -30.9569 -4.46587 +9412 4 17.442 28.7831 34.1436 -6.82268 9.96305 3.46007 +9413 4 17.4403 27.8723 32.949 -23.4552 19.8179 6.40974 +9414 6 33.6969 30.8931 0.141175 14.1795 0.777253 -0.635822 +9415 4 34.6278 30.5945 0.162696 -6.8513 6.78484 1.91826 +9416 4 33.3211 30.3583 41.3463 -2.66034 -4.05802 -0.0970656 +9417 6 16.2525 21.5202 34.1552 3.2099 -15.0674 -0.387853 +9418 4 16.0099 20.7546 33.5903 4.90739 13.2878 5.87792 +9419 4 16.6977 21.1376 34.9376 -8.96682 7.2262 -10.6242 +9420 6 0.22977 17.7868 35.7492 -9.57638 -14.7124 1.37696 +9421 4 54.2434 17.9569 35.6827 28.6901 -4.22084 5.11773 +9422 4 0.351694 16.93 36.209 -4.1051 13.1178 -5.65765 +9423 6 16.8289 12.2962 0.019427 11.8958 12.8939 11.6481 +9424 4 17.3016 12.8498 0.703368 -12.3262 -21.137 -14.7379 +9425 4 16.4403 11.4936 0.411486 1.39397 8.07719 2.11333 +9426 6 8.24246 9.54397 36.2629 -25.8472 21.2414 2.40819 +9427 4 7.81464 8.9356 36.8788 1.26461 -2.06425 2.56422 +9428 4 7.48979 10.0869 35.9067 16.4576 -8.29365 1.86334 +9429 6 48.5761 26.718 39.8382 -16.8767 -13.2223 25.9758 +9430 4 48.2189 26.9037 38.9774 0.202946 6.43929 -15.4249 +9431 4 49.4865 26.9849 39.8847 17.129 6.93076 -9.10183 +9432 6 35.4777 1.07865 23.1156 20.3084 9.46551 28.8556 +9433 4 36.0215 1.72656 22.6213 -7.75205 -10.5654 8.45632 +9434 4 35.804 1.12911 24.09 -10.3378 -1.68949 -45.1242 +9435 6 20.2777 30.6326 19.3782 17.168 -16.4055 9.77372 +9436 4 20.2499 31.0311 20.2788 1.56461 -6.55175 -10.0354 +9437 4 20.938 29.881 19.3855 -20.6701 22.3694 2.2449 +9438 6 44.3702 15.9458 1.58361 10.9348 22.193 31.2112 +9439 4 44.4077 15.6379 2.51116 -1.71559 -1.42871 -18.164 +9440 4 44.6431 16.8967 1.66823 -9.97295 -22.8516 -13.6111 +9441 6 53.8845 34.4651 10.6068 -24.0145 7.95167 -19.3224 +9442 4 54.4361 34.2696 11.3314 22.7066 -9.19703 33.7305 +9443 4 54.2985 35.2035 10.1555 0.2437 -1.83103 1.50375 +9444 6 46.1364 32.8471 33.519 4.96533 -12.2334 2.48444 +9445 4 45.9404 33.6629 33.0556 -3.66306 8.73713 -2.86335 +9446 4 47.0477 32.6179 33.2654 -4.26196 1.19291 1.09329 +9447 6 42.1324 21.9098 24.2239 34.4777 -24.9191 34.4505 +9448 4 43.0412 21.5159 24.3646 -28.4667 14.3091 -11.1056 +9449 4 41.7437 21.6811 25.0949 -3.80951 9.2794 -19.6729 +9450 6 8.14185 3.89847 11.6387 2.30661 -15.3192 6.95264 +9451 4 7.35197 4.1174 12.1322 -8.99547 12.8437 -2.29886 +9452 4 8.35392 3.05748 12.0535 10.9023 -1.5691 -3.31016 +9453 6 19.6413 41.6808 9.8267 1.07442 6.29255 0.337359 +9454 4 18.9204 41.094 9.57509 0.414049 2.67892 1.92063 +9455 4 19.352 0.205183 10.6506 0.427822 -12.2572 -10.0953 +9456 6 42.3157 8.41085 31.6785 13.3628 11.5473 -7.23952 +9457 4 41.3969 8.42848 31.9417 -9.73605 -1.80426 0.915182 +9458 4 42.5534 9.35818 31.5624 -0.333442 -16.319 1.99913 +9459 6 26.911 16.154 25.3637 -0.10907 13.2502 -20.6653 +9460 4 26.7939 15.8861 24.4207 -0.565005 2.37017 21.4763 +9461 4 26.6835 15.4121 25.9182 -3.52016 -12.4926 6.14171 +9462 6 48.2345 6.48613 12.6212 -1.55264 -8.09911 -9.8466 +9463 4 48.9652 6.31914 12.0011 -5.93235 3.28214 2.19301 +9464 4 47.4516 6.10442 12.1764 7.36669 2.93589 5.65527 +9465 6 53.4556 41.5274 30.6561 0.928349 -3.66285 -10.4005 +9466 4 53.9738 41.8466 29.9077 -1.68735 -3.84443 -4.80087 +9467 4 53.7246 0.16796 31.3785 5.2081 5.34012 15.7103 +9468 6 47.0719 22.4215 31.8177 3.79963 28.0651 -15.4962 +9469 4 47.8542 22.5824 31.2379 -15.4047 -7.22606 14.7582 +9470 4 46.5391 23.2393 31.6689 5.43499 -22.2824 10.2038 +9471 6 19.5241 5.44646 15.2431 57.7261 9.00726 -25.1025 +9472 4 19.973 4.5781 15.2547 -6.4602 7.66804 1.10752 +9473 4 18.6769 5.33307 15.596 -47.9766 -8.78418 19.1468 +9474 6 14.6808 30.2445 33.392 16.954 11.9814 -17.0239 +9475 4 15.1668 30.8865 32.8123 -10.4914 -16.0898 10.6301 +9476 4 15.2553 29.4559 33.3904 -4.22445 9.80292 -0.52553 +9477 6 28.4427 24.2289 10.4187 -0.774793 -27.6212 -36.8967 +9478 4 29.277 24.4414 10.8128 10.21 14.4589 20.8069 +9479 4 27.7162 24.5027 10.9517 -9.91177 12.6254 22.5109 +9480 6 5.25429 14.4357 24.4952 18.8694 8.38265 -3.5804 +9481 4 4.38598 14.1455 24.6681 -43.369 -9.18674 12.4123 +9482 4 5.45154 13.9758 23.6794 9.52503 -2.95522 -10.1363 +9483 6 26.3476 19.2988 19.1857 11.4015 -18.2951 -12.5804 +9484 4 26.5417 20.1869 19.4853 3.52858 10.6793 1.31948 +9485 4 27.146 18.9308 18.7141 -21.2465 13.7562 17.259 +9486 6 28.5834 7.44603 13.1845 8.68409 29.8386 11.3246 +9487 4 28.3961 6.55455 12.9442 -2.45324 -19.0833 -9.20205 +9488 4 29.0571 7.89665 12.4686 -5.14786 -6.54739 -1.73865 +9489 6 5.35742 27.1473 37.0464 13.0843 -4.728 13.8292 +9490 4 6.09472 26.8663 37.6487 -17.7636 2.66278 -18.049 +9491 4 5.49884 28.0724 36.7882 1.93418 -3.90879 0.386893 +9492 6 53.1466 13.4128 16.1104 33.6732 -23.607 0.886679 +9493 4 54.0532 13.0537 15.8959 -24.4904 18.1541 2.55443 +9494 4 52.6056 12.6236 16.2807 -0.490038 10.6025 -2.0621 +9495 6 45.4595 1.03561 24.6152 0.883869 7.22473 8.82703 +9496 4 44.8005 0.912307 23.9218 -0.0838502 -1.3445 -1.23214 +9497 4 44.9845 0.757767 25.4168 6.19386 0.932014 -5.94613 +9498 6 50.1542 2.38642 13.9319 -2.4774 12.931 -1.3926 +9499 4 50.7815 2.76975 13.3044 0.014285 -4.08681 1.38242 +9500 4 49.5062 3.09016 14.0651 -1.63783 -0.639647 1.83323 +9501 6 19.5885 31.0175 39.1657 -10.9837 -21.6636 -18.6241 +9502 4 19.8079 30.3148 38.4832 -5.60324 21.7545 20.6111 +9503 4 18.6148 30.9453 39.3442 26.0441 2.6939 -5.02925 +9504 6 19.2491 14.7106 10.8907 20.9533 -11.5465 -13.087 +9505 4 20.0062 14.1954 10.4207 -44.2836 18.7066 28.5885 +9506 4 18.7045 14.0688 11.3882 14.1221 2.37282 -8.47947 +9507 6 4.44986 39.5549 20.1348 -7.46971 20.8744 22.4052 +9508 4 3.99116 40.4291 20.2667 12.3042 -22.0468 -4.08326 +9509 4 4.78876 39.261 21.0122 -11.398 5.88582 -21.7205 +9510 6 29.0264 13.3645 23.891 3.80322 20.0192 21.3715 +9511 4 28.7263 12.4558 23.8574 1.87437 -3.97007 -2.19356 +9512 4 28.9189 13.5991 24.8488 7.01015 0.856522 -27.3099 +9513 6 17.0674 2.76528 17.6511 13.6679 -9.88609 -24.0062 +9514 4 16.9089 3.43106 16.9566 -0.337692 -4.66999 2.92783 +9515 4 17.7694 2.16287 17.2836 -16.7881 13.7863 9.44417 +9516 6 43.472 18.0456 17.7207 2.90116 -6.00314 -10.3001 +9517 4 43.5328 17.0661 17.6262 0.602958 19.7978 9.46789 +9518 4 43.5843 18.2505 18.6627 0.176297 -8.32564 -1.3476 +9519 6 25.7838 40.7303 1.24723 -3.64329 26.5644 -28.0564 +9520 4 26.2198 41.3001 1.88369 1.46132 -2.86659 8.1156 +9521 4 25.5777 41.3986 0.532216 -2.57635 -28.6607 13.7824 +9522 6 0.458758 22.8928 6.22327 -2.28892 -3.37321 -2.62932 +9523 4 0.911995 22.0955 5.88137 -3.49653 6.37629 4.11618 +9524 4 1.15027 23.4262 6.63616 1.38998 -0.611711 -3.15133 +9525 6 26.2502 35.0072 18.629 11.2346 5.37396 -16.6635 +9526 4 25.9102 35.926 18.5821 -1.77201 -16.2127 4.61622 +9527 4 25.7094 34.5197 19.2578 -0.594129 4.22999 1.61862 +9528 6 16.1509 31.8837 7.54876 40.1408 -29.5169 -1.86921 +9529 4 16.9528 31.2446 7.38162 -38.5191 36.6879 6.5811 +9530 4 16.2422 32.6162 6.9246 8.25996 -4.45471 -3.71716 +9531 6 22.9569 16.8424 28.5503 -18.0144 15.9011 -12.9281 +9532 4 23.0242 16.0615 27.9964 2.65193 -8.47258 -0.731728 +9533 4 22.0914 17.2685 28.2981 23.9965 -14.5366 15.8079 +9534 6 48.817 29.3453 32.1483 10.2159 -3.67765 25.2301 +9535 4 47.913 29.23 31.8533 -10.4354 1.38436 -5.08298 +9536 4 48.8482 28.9579 33.0615 0.343667 8.53482 -20.1614 +9537 6 13.1275 24.857 5.54597 -15.7655 12.0094 -10.6158 +9538 4 12.8967 24.1126 4.95892 -3.19147 7.26676 2.83523 +9539 4 12.4206 25.5605 5.45199 17.9822 -22.1189 1.55356 +9540 6 10.967 20.7149 15.8389 3.49035 -8.57129 -4.90872 +9541 4 10.8232 20.5385 14.8814 6.84933 2.21154 19.4522 +9542 4 11.8211 20.2878 16.0966 -18.2767 7.30584 -13.8769 +9543 6 13.8574 18.376 6.9425 -18.5688 18.5302 -26.9748 +9544 4 14.0551 19.3329 6.99178 3.58444 -10.9562 5.12073 +9545 4 14.2751 17.8929 7.64202 12.8225 -6.30863 19.0643 +9546 6 13.8485 12.9413 30.6405 -7.33075 -24.1801 -9.47477 +9547 4 13.9233 12.3923 29.8469 14.5901 9.31788 -1.12157 +9548 4 13.0284 12.552 30.9634 -3.13873 11.8242 15.1361 +9549 6 17.1199 6.33729 31.2705 58.4108 60.4292 21.9502 +9550 4 16.7347 7.19592 31.0485 -2.55536 -2.82538 -1.05014 +9551 4 16.4932 5.72664 31.0455 -61.4006 -55.6776 -22.0804 +9552 6 7.63858 23.4232 20.5528 2.70849 -2.51933 -11.6338 +9553 4 7.34936 23.0623 19.6936 2.42656 1.66026 8.60009 +9554 4 8.06294 24.2698 20.3247 -2.54411 -7.58863 2.30144 +9555 6 15.6012 36.6828 25.6308 12.0382 0.865576 2.42327 +9556 4 16.546 36.4866 25.8589 -19.7129 13.5166 -7.57965 +9557 4 15.5566 37.5233 25.1245 15.7859 -9.47529 6.9914 +9558 6 0.738662 10.4099 22.1708 -26.6289 -22.4058 -14.7131 +9559 4 0.0268398 10.3645 21.4686 20.8647 0.21224 20.3485 +9560 4 0.555589 9.63254 22.7491 3.84168 18.0907 -12.5939 +9561 6 33.5034 17.3959 33.5951 21.201 30.6084 -13.4811 +9562 4 33.5895 18.3893 33.3705 0.776259 -45.1899 5.95193 +9563 4 34.1847 16.8766 33.1005 -9.04546 14.4589 8.38708 +9564 6 21.6622 19.013 20.7578 31.9274 -22.1518 -4.15649 +9565 4 22.4096 19.6032 20.9777 -11.5486 -3.71871 -1.82252 +9566 4 22.1307 18.1402 20.6082 -20.9219 25.304 3.1187 +9567 6 41.7583 19.992 16.8792 -6.68772 4.02339 -8.69865 +9568 4 42.2438 19.1637 16.9575 3.64207 -5.49479 0.617993 +9569 4 41.579 20.1273 15.9247 3.71595 -2.33609 11.0843 +9570 6 12.0355 14.9654 17.6922 -21.5841 1.26502 -18.8824 +9571 4 11.2182 14.5976 17.276 14.8021 5.3277 12.4216 +9572 4 12.4319 14.255 18.1907 -0.352973 -10.2116 7.98966 +9573 6 23.0172 11.4191 40.7206 -10.7217 24.0381 44.0704 +9574 4 22.9528 12.3236 41.1181 -0.480688 -24.3492 -4.33206 +9575 4 23.3445 11.5906 39.8675 15.3819 0.516123 -37.823 +9576 6 21.0055 28.3299 24.5595 -23.1154 26.0001 -7.02903 +9577 4 20.2855 28.1767 25.1713 -12.8069 16.7504 -3.2857 +9578 4 21.5564 27.6405 24.838 35.6802 -30.9994 4.41974 +9579 6 19.406 13.705 31.9364 14.5236 -8.57279 10.3452 +9580 4 18.7521 13.9469 31.2876 -5.81883 0.611034 -8.78432 +9581 4 18.9142 13.6788 32.7621 -0.186305 1.04404 6.29106 +9582 6 21.5918 2.86134 24.7058 -12.3779 12.1824 -8.79066 +9583 4 21.7274 3.16074 23.7816 9.4572 -7.89437 13.7797 +9584 4 22.4025 2.45534 25.0386 5.22934 2.42127 -4.70961 +9585 6 11.3487 29.9838 18.827 10.5554 -3.16976 4.47537 +9586 4 10.5352 30.5203 18.751 15.2364 -2.61973 2.60085 +9587 4 12.0043 30.4181 19.4217 -22.0541 -6.82347 -15.9561 +9588 6 14.6417 22.3529 8.3686 35.183 35.1516 7.4005 +9589 4 14.0314 23.0645 8.61446 -9.87113 -8.59651 0.991548 +9590 4 15.5117 22.8693 8.31218 -34.203 -30.7208 1.23805 +9591 6 43.9533 23.6664 17.2647 -9.15762 31.6597 -10.4885 +9592 4 44.7744 23.2846 16.9678 11.7125 -13.1472 -3.62648 +9593 4 43.5104 22.9908 17.7726 1.91474 -8.51607 6.21827 +9594 6 28.003 25.5014 27.4986 6.23457 -29.1533 -5.23677 +9595 4 27.4849 26.2827 27.5489 -17.6876 27.9136 1.36856 +9596 4 28.906 25.8001 27.3829 8.21911 6.89622 0.0845564 +9597 6 19.1046 26.8047 33.1413 12.2661 11.24 -48.0243 +9598 4 19.0365 26.4782 32.1917 1.11076 11.999 35.7369 +9599 4 19.4769 27.7251 33.0545 -9.7287 -23.6705 8.34301 +9600 6 6.37289 19.3428 5.67363 -3.21133 -16.2285 8.07537 +9601 4 6.7336 20.019 5.09886 3.22925 8.22387 -6.14542 +9602 4 5.58923 19.7346 6.08082 -0.796808 3.74051 2.3056 +9603 6 37.4835 28.3972 9.67963 -16.8252 8.64443 -22.9196 +9604 4 37.8384 28.0931 10.5154 1.79485 -10.7977 1.13655 +9605 4 37.3056 27.6421 9.07717 9.05958 5.47813 21.4583 +9606 6 17.6994 27.086 11.7957 -23.9049 -9.71644 -0.114793 +9607 4 16.9894 26.5877 11.2784 19.3807 18.9653 23.0761 +9608 4 17.3772 27.2467 12.7205 1.32974 -4.86863 -22.184 +9609 6 12.8804 1.95044 24.1635 -16.9081 23.6463 -41.3936 +9610 4 12.0123 2.42693 23.9788 24.6345 -20.1638 18.4271 +9611 4 12.9602 1.63912 25.0531 -11.2641 -4.9093 21.6908 +9612 6 27.8486 37.1249 33.3037 14.5525 0.843809 -12.8082 +9613 4 27.8306 37.7566 32.5563 -0.261378 -9.54721 11.1245 +9614 4 28.4641 36.389 33.0416 -14.495 18.5162 4.94281 +9615 6 18.6769 12.3657 6.31954 -0.243732 -29.9473 12.6257 +9616 4 18.5317 11.3932 6.23771 0.963018 17.4883 6.62231 +9617 4 18.5535 12.6707 5.42951 -3.51714 10.9469 -19.8301 +9618 6 10.1845 29.3127 24.783 -1.36331 5.89889 -4.08473 +9619 4 10.7465 29.1085 25.5662 -10.353 -5.60455 -9.55427 +9620 4 9.5047 28.6152 24.6271 17.6265 9.93184 12.3415 +9621 6 7.25219 3.30976 16.2618 16.5712 6.01323 38.0962 +9622 4 7.85224 3.92676 16.743 -7.28275 2.21025 -21.7569 +9623 4 7.07626 2.67339 16.9792 -0.839688 -3.96601 -21.0406 +9624 6 32.2032 37.556 1.10106 -1.45173 2.30566 -1.67736 +9625 4 31.7319 37.0242 1.72254 -12.3544 -30.6614 1.12887 +9626 4 32.1826 38.3533 1.61216 9.84976 31.1212 -1.90535 +9627 6 10.4132 10.1536 6.41547 2.6172 -5.66149 -5.23088 +9628 4 9.51094 10.4988 6.43252 -1.43241 7.72691 5.99088 +9629 4 10.888 10.4598 7.20926 -10.4429 3.02901 -4.20627 +9630 6 16.1922 23.2473 37.3836 13.4596 17.9231 -6.20094 +9631 4 16.4628 23.5362 38.2769 -1.8179 -2.41291 -6.91424 +9632 4 16.622 23.8878 36.7607 -9.68345 -13.0364 13.8052 +9633 6 24.0933 14.3373 36.5438 -0.810617 7.47513 6.008 +9634 4 25.0172 14.0983 36.6068 9.64822 -3.29568 0.232999 +9635 4 23.7283 14.0715 37.4031 -3.57511 2.15125 -3.19243 +9636 6 27.4694 18.5535 28.7878 -22.2405 -8.90967 9.68842 +9637 4 27.2463 18.155 29.6474 7.14424 4.94771 -10.1046 +9638 4 26.6163 18.5328 28.3045 10.7583 2.44378 -0.411902 +9639 6 51.5617 10.4928 1.56364 -46.044 -5.31617 -17.9438 +9640 4 50.711 10.1131 1.91707 23.1705 13.8427 -10.0979 +9641 4 52.2015 10.4284 2.24991 18.8641 -3.04547 25.194 +9642 6 31.1163 39.6073 27.5052 16.7753 -4.77526 -29.689 +9643 4 30.6203 39.2762 28.2489 -5.6675 10.9492 15.0474 +9644 4 31.3773 40.5466 27.6182 -8.67746 -20.5696 10.3555 +9645 6 6.90447 35.9666 14.3264 -30.1691 -4.34312 14.222 +9646 4 7.61578 36.3042 13.808 21.2575 5.14969 -9.00238 +9647 4 7.11482 35.0613 14.5906 3.01946 -0.973686 -2.74545 +9648 6 45.5514 7.57029 29.1841 -25.615 -5.69379 -2.02895 +9649 4 44.9198 7.51228 28.4263 15.6429 0.393509 16.1679 +9650 4 45.0848 7.11279 29.9186 7.09759 5.05324 -8.24334 +9651 6 31.3626 20.5603 31.6216 46.5235 7.85379 -13.5612 +9652 4 31.9622 21.3332 31.7077 -20.5518 -6.12612 6.97271 +9653 4 31.9328 19.9839 31.0823 -17.3109 -3.90007 7.28444 +9654 6 43.0286 31.1606 10.377 -16.6603 7.93207 28.9623 +9655 4 42.0878 30.8529 10.4887 24.119 8.07098 -2.29185 +9656 4 43.3099 31.4942 11.272 -6.72297 -13.7816 -28.1326 +9657 6 50.925 25.5606 12.6461 -27.6852 -6.08767 20.8539 +9658 4 50.917 26.3683 12.1731 -8.31821 35.0391 -16.2433 +9659 4 51.8024 25.2628 12.5325 34.7451 -18.8429 0.848912 +9660 6 29.3305 2.97987 3.64738 17.2649 -36.5424 -5.61333 +9661 4 29.6156 3.84373 3.86529 8.03017 35.8359 9.57326 +9662 4 28.4158 3.03535 3.41816 -23.9953 6.75187 -10.8335 +9663 6 53.9216 32.1051 20.3724 -11.2223 -0.478332 -4.16652 +9664 4 54.8523 32.157 20.1701 8.27859 1.2318 1.83366 +9665 4 53.5473 31.7256 19.5583 -4.88871 3.83013 8.11791 +9666 6 41.7036 29.5569 6.48267 17.2638 16.7804 -5.64052 +9667 4 40.7698 29.5903 6.27928 -11.16 5.83742 -3.44443 +9668 4 42.1548 30.305 5.99503 -16.5783 -19.3567 12.2041 +9669 6 37.8345 24.5719 39.3019 -13.0469 -9.65298 -3.86921 +9670 4 37.225 24.2046 38.6488 4.5791 4.74434 1.49749 +9671 4 37.4276 24.3068 40.1372 5.55374 4.45167 1.85829 +9672 6 46.5621 27.5658 23.2944 -23.9279 -33.0439 -11.1022 +9673 4 46.4387 27.4786 24.2739 -2.64996 -4.90603 -22.3791 +9674 4 45.938 26.8598 22.8442 32.7587 35.3455 32.269 +9675 6 9.23408 27.197 8.34767 -28.7607 6.82988 18.9345 +9676 4 8.89078 27.6282 9.16421 9.10203 -8.06063 -16.3167 +9677 4 10.1694 27.1106 8.44975 24.8451 0.83524 4.07321 +9678 6 36.0586 34.168 13.9947 0.546429 -20.5208 -0.995849 +9679 4 35.8317 33.2019 13.9926 1.47243 21.3574 0.844463 +9680 4 36.7518 34.2454 13.3214 -1.12661 -0.38848 2.20278 +9681 6 51.6812 14.492 12.3108 14.2062 7.57429 -10.7818 +9682 4 52.2015 14.4126 11.4771 -7.23407 7.45688 18.698 +9683 4 51.902 15.34 12.7416 -3.60656 -14.3916 -9.37264 +9684 6 15.248 19.6366 32.4109 27.4357 -16.6396 -20.9158 +9685 4 15.2931 19.2358 31.5053 -3.54534 7.22564 18.4797 +9686 4 14.3328 19.7639 32.5881 -28.0981 2.1384 2.91772 +9687 6 27.6849 24.6479 38.3573 2.41004 -14.3506 -18.7558 +9688 4 27.9256 25.2107 39.0738 -0.349992 17.1553 25.2623 +9689 4 28.4455 24.6938 37.7731 2.45273 -2.47407 -6.18841 +9690 6 37.5344 9.26205 13.6222 2.62805 -1.42602 2.92011 +9691 4 37.9029 8.73293 14.3466 0.897712 0.834078 0.0180659 +9692 4 37.323 10.115 14.0326 -0.799981 -1.44542 -1.10758 +9693 6 20.9013 33.2307 26.2512 6.46074 3.54373 3.40895 +9694 4 21.2661 33.4546 27.1222 -3.70394 5.03607 -5.2507 +9695 4 21.0534 32.294 26.1755 2.06129 -12.757 -1.69162 +9696 6 6.58179 13.9421 35.2385 -0.161437 -23.8226 2.06013 +9697 4 6.46846 12.9778 35.1898 -10.847 5.63462 -0.921172 +9698 4 7.53649 14.0007 35.2781 8.40152 11.229 1.63712 +9699 6 10.0736 7.47184 6.87074 6.29005 1.76204 -5.26249 +9700 4 9.16789 7.18556 6.66525 -0.124912 3.45645 -0.864518 +9701 4 10.1825 8.41968 6.63706 -5.90018 -13.0861 3.35766 +9702 6 31.1989 5.96627 11.4256 47.5137 28.7614 23.6553 +9703 4 31.4466 6.13876 12.388 -20.2952 -9.94335 -33.1747 +9704 4 32.0308 6.26994 10.9806 -22.1211 -12.2896 5.82222 +9705 6 12.1387 3.84993 35.2935 2.49551 -0.304387 23.4243 +9706 4 12.8187 4.19174 34.7257 10.4227 4.50872 -14.559 +9707 4 12.5185 4.00559 36.1769 -9.60543 -1.42105 -7.76228 +9708 6 5.33665 6.07757 27.6447 8.69228 -34.5823 40.5077 +9709 4 5.10952 6.83187 28.1919 -5.14709 12.9851 -0.252954 +9710 4 5.24124 6.31071 26.7545 -7.00092 22.4827 -45.3835 +9711 6 13.1372 33.5675 1.68451 12.1014 31.5323 -4.45098 +9712 4 12.5865 33.1501 1.03303 -8.81838 -7.47149 -8.20936 +9713 4 13.3352 34.4765 1.32576 -5.5291 -24.3721 14.4697 +9714 6 44.6567 10.4099 29.0319 -12.4525 3.56979 -21.9228 +9715 4 44.5737 9.45178 29.0051 9.95574 -3.72472 2.79876 +9716 4 44.0317 10.7133 28.332 10.7873 2.60441 13.9487 +9717 6 9.14585 24.5947 6.38022 15.9839 26.3438 -7.73853 +9718 4 8.92734 24.382 5.47582 -9.1117 -9.61509 -8.5024 +9719 4 9.72625 25.3768 6.21639 -5.50996 -10.1894 15.5503 +9720 6 52.5653 27.2618 21.6392 -6.48047 6.16108 13.4347 +9721 4 52.5564 26.3196 21.8908 4.78081 5.6644 -14.1528 +9722 4 52.8195 27.3969 20.7225 3.24319 -11.7343 -6.41363 +9723 6 7.29679 16.9603 33.544 -1.27463 2.76823 -11.9762 +9724 4 7.39152 17.7215 32.9493 2.03275 -0.910573 2.88066 +9725 4 6.37085 16.7082 33.4809 -4.66481 0.778096 -0.770576 +9726 6 43.9289 25.2227 7.97871 -4.96366 -10.0233 8.38699 +9727 4 43.2519 24.7308 8.49213 12.2574 5.67032 -8.3389 +9728 4 43.4276 25.9018 7.51862 -3.04483 5.5605 -3.23664 +9729 6 2.07953 27.1233 13.6028 0.0104954 7.16496 -8.77242 +9730 4 2.15896 26.2371 13.9627 -2.1358 -7.6126 6.04882 +9731 4 2.6502 27.1018 12.8141 -2.23666 2.89631 3.72058 +9732 6 37.3141 18.284 2.18477 -5.94753 -1.23785 7.60386 +9733 4 37.4961 17.5691 1.55591 -3.17432 -0.490531 -1.7774 +9734 4 36.7255 18.8979 1.7415 -3.03937 1.4219 -5.67571 +9735 6 25.0022 10.0655 0.429871 -30.1443 -7.37242 -0.593153 +9736 4 24.272 10.366 41.7528 14.2211 1.75124 5.05026 +9737 4 24.5705 9.40237 1.00583 14.7283 12.1051 -6.86513 diff --git a/examples/amoeba/dump.water_box.amoeba.1.test b/examples/amoeba/dump.water_box.amoeba.1.test new file mode 100644 index 0000000000..9019401850 --- /dev/null +++ b/examples/amoeba/dump.water_box.amoeba.1.test @@ -0,0 +1,7227 @@ +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.67966 7.08769 17.9461 -18.0057 -16.954 4.82612 +2 2 7.80945 6.75579 18.2607 19.8034 12.4721 -7.17463 +3 2 8.72223 6.81424 17.0254 7.13784 0.0282027 3.08606 +4 1 18.5257 8.24445 6.83762 8.52147 14.2257 60.5703 +5 2 0.216892 7.89544 6.05003 12.0964 -15.6711 -53.3384 +6 2 0.444268 7.82601 7.5302 -13.3675 6.47926 -9.3119 +7 1 8.37906 18.5504 6.81463 24.6094 6.61103 -1.11969 +8 2 9.34042 0.098069 6.73406 -18.7879 -2.64022 0.747908 +9 2 7.93962 0.573676 6.26984 -2.09268 1.16699 2.67386 +10 1 6.58995 1.84432 11.7198 46.7475 -13.739 -10.5489 +11 2 5.88543 2.40231 11.9251 -37.1346 27.545 16.57 +12 2 6.18153 1.06275 11.3693 -7.36455 -17.4045 -5.52161 +13 1 7.1466 5.75358 2.33152 -53.3657 41.599 -1.38826 +14 2 6.36812 6.12603 2.86268 38.0857 -22.9036 -2.95785 +15 2 7.02502 6.29465 1.5182 16.1101 -20.4591 11.2904 +16 1 16.2164 10.1388 16.1382 -32.9296 19.8915 17.3579 +17 2 16.9509 10.2747 15.5847 32.6569 -1.09677 -20.2087 +18 2 15.8498 11.0405 16.2399 2.59134 -12.8635 2.30838 +19 1 10.6046 15.0374 2.30369 -9.45108 -28.933 -9.95229 +20 2 10.5292 14.3949 3.01849 1.67759 -0.529274 5.48943 +21 2 11.0236 15.78 2.70962 13.2591 21.3673 6.11781 +22 1 17.1624 8.24409 10.3708 10.41 5.9387 11.3227 +23 2 16.5528 8.68798 10.966 -4.81374 9.55532 3.583 +24 2 17.9421 8.82333 10.3208 -3.63548 -8.99367 -3.64514 +25 1 14.901 15.8652 16.3167 21.2892 -10.1645 16.79 +26 2 14.0225 16.1982 16.2525 -30.7371 12.6366 -7.00126 +27 2 14.9141 15.482 17.2099 1.64171 -7.21798 -3.7798 +28 1 12.1752 13.3771 0.408263 -10.449 7.39269 11.8256 +29 2 12.0579 13.8465 18.23 5.34035 -4.48355 -17.1718 +30 2 11.6217 13.8904 1.00796 2.45905 -0.157672 9.39156 +31 1 9.27358 5.34243 4.05546 -29.354 32.8373 13.3322 +32 2 8.64594 5.4665 4.83764 23.9402 -17.6274 -26.2044 +33 2 8.74177 5.68615 3.30282 4.39732 -15.4932 8.77495 +34 1 1.83016 4.27673 11.6495 -22.4867 33.9085 -11.1027 +35 2 1.70328 5.22377 11.9391 5.26663 -24.2909 -6.35354 +36 2 2.40811 3.85345 12.2597 16.6835 -12.3735 20.3319 +37 1 1.96438 6.83299 8.3731 -11.8866 6.09586 -26.8326 +38 2 2.49614 7.21578 9.0563 11.4719 0.0715494 18.6532 +39 2 1.81128 5.90585 8.57354 7.57659 -6.58781 5.32172 +40 1 5.40557 4.38899 7.93274 -5.84675 9.40812 -2.24834 +41 2 5.53738 3.43895 7.78131 -7.95286 9.95376 -0.129754 +42 2 4.75516 4.73491 7.29062 11.2407 -18.5615 7.61563 +43 1 3.23 2.92842 17.5524 1.14755 15.2746 17.0601 +44 2 3.93109 3.19827 16.9402 0.871842 10.3641 0.782189 +45 2 3.00444 3.70897 18.1497 2.9668 -26.2705 -22.3315 +46 1 7.4624 5.26283 6.13117 4.99569 4.7543 -2.87263 +47 2 8.02565 5.58849 6.88177 -21.8117 -10.641 -11.2175 +48 2 6.93508 4.45577 6.3254 15.5754 16.5621 10.3274 +49 1 9.77896 7.02384 11.9834 11.1892 -4.91774 24.9965 +50 2 10.2721 6.37256 11.5011 12.944 -11.2243 -3.64487 +51 2 9.1532 7.31587 11.3499 -25.3515 14.1302 -21.9158 +52 1 14.1167 3.54999 8.03003 -26.7224 -2.96987 -36.9282 +53 2 13.4732 4.22413 7.73132 14.0058 -9.36539 3.16858 +54 2 14.3809 3.80189 8.88487 12.5079 17.7406 36.8421 +55 1 4.82329 17.2568 4.03846 -17.1239 31.8599 -29.451 +56 2 5.49315 17.973 4.01308 -7.2715 -20.7015 10.2799 +57 2 4.18746 17.5412 3.33843 11.1391 -13.8034 10.6312 +58 1 16.4918 16.6259 10.0493 30.7319 18.7558 -40.9431 +59 2 16.1673 16.3226 10.8594 -24.9276 -14.9205 38.9888 +60 2 15.9925 16.2084 9.33562 -5.59472 -4.21747 7.16045 +61 1 1.94489 4.93323 0.49791 29.2037 9.87254 4.22328 +62 2 2.55322 5.26335 1.2053 -16.134 -9.14189 -14.6469 +63 2 2.08253 5.591 18.4408 -15.0883 -1.49688 2.64821 +64 1 11.816 13.3571 16.2711 -9.40148 3.94995 7.41554 +65 2 11.2371 12.6203 16.5671 11.2868 -0.226619 -16.3723 +66 2 12.2446 13.1893 15.4079 -8.93504 -7.51369 10.5349 +67 1 10.105 11.0651 16.9545 19.171 -30.5561 3.11717 +68 2 10.5674 10.1947 17.1295 -13.2328 27.8223 -6.21699 +69 2 9.25349 10.8067 16.5912 -4.96621 2.04172 2.74708 +70 1 11.7264 17.5421 13.4742 -3.04385 -27.7441 -11.1528 +71 2 12.2771 16.9836 12.8968 -5.80236 0.92931 5.24929 +72 2 12.1041 18.3936 13.317 3.92972 25.4072 2.69815 +73 1 6.33029 9.31911 12.2264 14.5686 -26.7823 -24.0739 +74 2 7.02603 8.96242 11.6353 -16.9594 2.64581 0.0898615 +75 2 6.81249 9.95941 12.7172 6.645 23.591 18.9185 +76 1 16.2187 12.7249 2.70186 -8.60429 -40.8729 7.98732 +77 2 17.0292 13.1566 2.50302 21.6794 20.3416 -10.6726 +78 2 15.4982 13.3357 2.61812 -11.4268 23.7847 2.88762 +79 1 0.637202 12.5625 5.84914 -31.8402 8.87564 3.58131 +80 2 0.892312 12.5507 4.90771 -4.9886 -2.92912 11.9697 +81 2 18.3039 12.804 5.85329 37.806 -5.77498 -8.15105 +82 1 5.19922 16.3781 18.5047 -8.79571 2.1563 -13.4584 +83 2 5.80284 15.8543 17.9455 2.86332 8.92403 13.1762 +84 2 5.67034 16.9636 0.462296 7.01287 -6.10758 -1.1835 +85 1 0.510145 7.62945 4.0545 45.1401 15.6351 -20.049 +86 2 18.5719 8.14656 3.45296 8.17292 -14.6601 7.70417 +87 2 1.46496 7.74082 3.66917 -48.4928 -0.554047 23.6518 +88 1 3.14672 8.89584 6.52626 -55.2927 3.32392 -1.46176 +89 2 3.50609 8.59991 7.35294 11.5609 -2.03159 9.82262 +90 2 2.14573 8.92962 6.68203 43.6989 0.357582 -10.1043 +91 1 7.30854 10.3037 16.1717 1.78466 -0.469392 13.5048 +92 2 6.56213 10.4624 15.5802 -0.177974 -0.17468 9.69093 +93 2 6.99303 10.278 17.1118 -1.93161 2.46429 -18.5659 +94 1 11.1122 1.06968 4.98939 -2.5529 -18.3754 16.0671 +95 2 11.0776 1.97142 4.64864 2.28669 -2.46607 -13.2595 +96 2 10.7048 0.433547 4.37027 3.43033 14.549 -3.59534 +97 1 4.45204 2.70061 13.2052 -5.66348 -30.5004 33.0628 +98 2 4.60333 3.05865 14.0914 -1.92534 16.2672 -14.1546 +99 2 4.38645 1.737 13.4626 -0.349226 19.9023 -23.5316 +100 1 8.42792 10.0237 1.78469 -10.3917 -19.899 15.7952 +101 2 8.3405 10.6377 2.53622 4.61332 0.207175 -2.25283 +102 2 8.49672 9.11244 2.17467 4.01989 28.7847 -10.326 +103 1 10.5335 1.75383 15.546 -34.1458 -0.453574 1.15961 +104 2 11.3977 1.82718 15.9216 24.1476 -5.37633 -0.0681618 +105 2 10.5608 1.78317 14.5837 3.50677 3.31298 -0.339701 +106 1 2.77693 12.941 7.74821 -10.4378 -0.583625 -1.53852 +107 2 3.28797 13.5733 7.23382 6.48403 3.62296 3.43855 +108 2 1.98704 12.8256 7.20013 3.29426 -8.64685 -0.0486837 +109 1 3.63517 11.6895 5.33963 -11.8109 -10.1864 -4.68879 +110 2 3.35385 11.0502 6.03137 5.66752 13.6786 -16.6554 +111 2 2.8758 11.855 4.74058 12.1084 -4.04172 11.1294 +112 1 6.88803 14.474 16.8428 -11.4129 11.5698 10.6698 +113 2 7.55973 13.8293 16.6383 5.64016 -3.74285 -2.32739 +114 2 6.60381 14.8838 16.0165 -1.10143 -9.42407 -1.70294 +115 1 14.1722 14.5374 3.41536 22.8916 -3.95473 -24.8295 +116 2 13.6514 15.2845 3.14096 -10.2906 15.0357 0.984662 +117 2 13.8512 14.2508 4.25439 -13.7068 -8.63673 17.9444 +118 1 8.28226 18.1809 16.0824 -12.751 -14.2632 -6.38017 +119 2 8.77677 17.3494 16.3071 3.86396 27.0257 -3.69586 +120 2 8.7603 0.384816 15.9919 13.8336 -15.3184 3.9152 +121 1 4.73724 1.61643 4.90111 4.42093 34.2728 -25.3552 +122 2 3.96969 2.16837 5.15263 7.5353 -10.5013 -8.47368 +123 2 5.18465 2.1484 4.15475 -16.3947 -25.6944 40.0476 +124 1 15.1457 12.8616 16.4403 -17.2871 -9.38827 44.2976 +125 2 14.6041 12.8692 17.2613 20.1997 8.40389 -10.3991 +126 2 14.49 12.6307 15.8136 -19.9308 -5.03226 -40.1466 +127 1 15.779 18.3837 16.786 46.4421 11.1965 42.4368 +128 2 16.5108 18.615 17.4688 -40.0732 -8.23978 -31.409 +129 2 15.7694 17.4186 16.7687 -10.9286 -0.13557 -0.275231 +130 1 1.1383 1.1331 16.5571 -3.78806 10.8903 6.59298 +131 2 1.96551 1.50352 16.9177 -13.4358 3.04324 -1.88802 +132 2 0.420521 1.53444 17.0916 18.9396 -8.74897 -5.5358 +133 1 18.0817 4.5907 15.863 15.5867 -18.8741 -0.0488223 +134 2 18.5818 3.91936 15.3489 -11.2031 15.1049 7.34982 +135 2 18.5602 4.7339 16.6874 -0.349245 -1.77666 -1.18458 +136 1 12.22 16.9378 16.1148 -5.50141 -11.6153 60.0453 +137 2 11.409 16.6934 16.6676 25.9686 4.83442 -31.2532 +138 2 11.9646 17.3216 15.2917 -16.184 2.10738 -25.7541 +139 1 15.8709 2.55221 17.9707 -0.937802 24.4841 -15.6355 +140 2 15.7355 3.48355 18.2574 7.57333 -26.0521 3.95198 +141 2 15.6659 2.59235 17.0072 3.66916 -5.77112 18.206 +142 1 6.70868 13.791 10.2637 2.56639 25.7323 0.00368182 +143 2 6.59347 13.548 11.1958 -0.357243 -4.92282 -5.01928 +144 2 6.58252 13.0514 9.6765 -3.72683 -17.1721 -0.802691 +145 1 10.146 18.2027 2.80372 18.7695 36.9578 -11.0057 +146 2 10.2207 0.331961 2.18345 -3.04248 -21.6078 13.7214 +147 2 9.26571 17.8868 2.67703 -19.5044 -8.44618 -8.21612 +148 1 2.97538 17.748 6.06078 -25.8303 0.797173 6.8887 +149 2 2.09399 17.6473 5.67013 0.763714 -3.05404 12.9421 +150 2 3.45883 17.8838 5.26396 31.3429 0.483929 -10.2997 +151 1 12.558 17.0134 7.97028 5.92903 -16.4499 -7.28316 +152 2 11.9572 16.2512 7.82085 0.921176 10.9238 13.6165 +153 2 12.4657 17.4524 8.83591 -10.9555 -3.32417 -4.29455 +154 1 14.8795 15.2862 8.28544 4.29768 -18.9738 42.4504 +155 2 13.9824 15.6136 8.40666 -1.92729 9.60106 -14.0248 +156 2 15.2312 15.4641 7.43118 3.9302 10.2131 -33.7787 +157 1 17.5429 18.3228 0.375372 -51.2916 -3.32975 -15.7386 +158 2 18.116 17.6308 0.128652 39.2354 -21.6017 -8.51882 +159 2 17.9698 0.288559 0.934677 25.0864 23.4945 21.3611 +160 1 0.910209 10.3712 1.41143 1.2541 -53.8465 46.4292 +161 2 0.158544 9.88347 1.87089 19.8792 18.5163 -27.3041 +162 2 0.565924 11.0969 0.944383 -23.7591 37.8535 -27.1782 +163 1 1.55407 12.175 3.31087 17.0236 24.8743 53.6813 +164 2 1.36245 11.4802 2.72234 -7.32763 -23.5838 -35.6732 +165 2 1.61623 13.0206 2.87285 0.136729 5.19924 -18.0355 +166 1 0.543127 17.2543 4.88609 31.8084 34.0538 -50.8525 +167 2 0.11032 17.9772 5.31124 -21.3387 12.8349 12.3342 +168 2 0.420366 16.4266 5.2673 -11.294 -44.4064 35.6607 +169 1 1.10053 1.01949 9.38768 20.2638 -3.47079 3.57058 +170 2 1.46081 0.575286 10.1589 5.67003 5.93636 13.5245 +171 2 0.265613 0.594128 9.34525 -28.6257 -3.15214 -10.2647 +172 1 16.8007 2.32783 13.2877 6.99662 17.0137 -29.7497 +173 2 17.0701 2.57314 12.3549 -10.9982 -8.19012 27.7721 +174 2 16.4263 1.43993 13.282 0.147057 -7.47121 1.20179 +175 1 2.45231 15.8283 12.1942 24.161 -10.1121 18.9704 +176 2 2.8623 15.5513 13.0537 -7.72007 6.59246 -26.0318 +177 2 2.91392 15.3801 11.4615 0.0476102 5.48907 2.61928 +178 1 16.435 15.531 5.9458 18.7492 36.0842 -19.2976 +179 2 17.3808 15.5177 6.20547 -11.8351 -4.55683 5.24266 +180 2 16.4147 16.2211 5.22063 -11.381 -14.928 22.2973 +181 1 5.84547 5.02056 11.8065 17.7106 -18.2202 -11.4458 +182 2 5.55799 5.91374 11.8891 -12.2572 20.16 10.1838 +183 2 5.09 4.45915 11.9819 -6.52029 -3.58907 3.63352 +184 1 15.2214 4.86555 0.731755 -13.1216 -14.4231 22.9417 +185 2 14.6776 4.45845 1.47821 22.203 16.7553 -20.5876 +186 2 14.6696 4.95834 18.5986 -12.3693 6.08689 2.65647 +187 1 16.3401 16.2933 2.11217 18.14 -13.9799 -32.9854 +188 2 16.0666 16.7695 2.87319 -13.0548 23.8975 25.5489 +189 2 16.7601 16.9279 1.50378 -12.2165 -0.858221 10.4248 +190 1 0.305885 4.87877 3.79118 -8.03527 51.7998 21.7755 +191 2 0.299338 5.85541 4.09758 -2.9952 -44.8334 -24.4202 +192 2 1.16991 4.5635 4.03062 6.79251 -10.5604 -0.715716 +193 1 2.92501 14.9782 15.0356 -0.55527 3.1583 33.427 +194 2 3.0159 14.7264 15.9987 -0.365372 -5.40078 -25.4532 +195 2 2.35392 15.7535 15.1247 4.98076 9.37108 -6.84819 +196 1 1.1115 14.5727 9.55731 53.2995 18.2393 -15.0567 +197 2 2.08491 14.4157 9.46275 -24.2978 21.5236 -5.71591 +198 2 0.897072 13.7408 9.90248 -27.8007 -35.1999 18.1171 +199 1 13.6501 16.6688 11.5433 6.47975 17.456 -8.04391 +200 2 13.4697 17.4567 10.9694 -3.73037 -22.0736 15.6897 +201 2 13.5721 15.8897 10.9842 -9.76738 -0.866763 -1.05724 +202 1 4.73098 1.47842 0.720986 0.301824 -3.12152 0.469647 +203 2 4.27169 1.98826 0.034225 -8.26683 -3.93854 8.43126 +204 2 4.11741 0.788607 1.06182 2.96071 12.6313 -1.58966 +205 1 1.42158 18.4663 11.9139 -14.1117 26.2958 -21.249 +206 2 1.21766 0.394331 12.6648 1.16138 0.455671 2.39682 +207 2 1.94844 17.765 12.2423 13.6408 -23.7742 11.0988 +208 1 11.5498 10.1018 4.11619 25.3456 17.7005 -19.3629 +209 2 11.5687 10.5955 3.24216 -3.14233 -16.3641 23.7483 +210 2 12.4899 10.1059 4.45555 -25.4417 -1.6091 -14.3563 +211 1 8.38254 12.182 3.76573 -28.852 -4.31545 3.66513 +212 2 9.25863 12.501 4.06076 -17.1001 4.9792 7.32521 +213 2 7.63736 12.4251 4.40785 39.3791 -3.23553 -14.7997 +214 1 14.3228 4.03714 3.29709 9.27375 -1.14036 13.2131 +215 2 14.8928 4.14179 4.10547 -9.51715 0.900554 -20.2647 +216 2 13.4701 4.45558 3.48891 4.64833 -1.13545 4.69814 +217 1 5.58188 1.78199 7.50513 -29.4992 -43.0538 46.7434 +218 2 5.0172 1.13958 8.12095 30.2312 35.5173 -41.7355 +219 2 5.33078 1.59122 6.59529 -0.079259 -3.9625 -11.0752 +220 1 17.9086 1.12503 4.88467 2.95857 -4.16946 -9.18468 +221 2 18.4038 1.54032 4.14207 -4.82318 -1.26447 16.1692 +222 2 17.6814 1.78344 5.55455 4.62183 1.86586 -4.7268 +223 1 6.83101 9.39303 4.49716 -16.0719 2.4093 -32.0921 +224 2 6.83675 9.57499 5.42715 5.68499 0.0447418 21.7322 +225 2 7.66807 8.99049 4.24996 11.5264 2.90932 7.40733 +226 1 2.71406 14.9654 1.962 -15.6661 -3.22344 -28.3015 +227 2 3.33343 14.7912 2.66354 12.1361 -6.91733 6.37301 +228 2 3.09502 14.6645 1.10257 -2.31521 10.6903 23.881 +229 1 17.279 12.8803 13.1283 -15.852 18.187 11.8592 +230 2 16.4044 13.2339 13.3283 -9.52452 -19.4408 0.302495 +231 2 17.6948 13.7346 13.0834 29.0619 4.95471 -11.8483 +232 1 15.0196 10.5818 1.38314 -38.2265 -36.9922 -31.977 +233 2 15.5102 11.1963 1.85791 34.2907 40.991 28.9525 +234 2 14.3351 11.0964 0.933298 3.32659 -5.3471 5.33786 +235 1 5.71789 6.95838 4.52856 0.683996 -27.8748 7.64407 +236 2 5.85266 7.87985 4.34179 3.58991 17.4746 0.820156 +237 2 6.44364 6.70841 5.13514 -10.315 -1.76088 -5.92415 +238 1 8.12142 8.26262 10.159 -0.695069 1.43108 44.445 +239 2 8.58519 8.93965 9.66877 7.60931 4.76567 -12.7632 +240 2 7.56021 7.74854 9.59836 -11.8614 -6.52029 -23.2391 +241 1 13.5311 18.2901 5.8079 -10.639 -13.2321 14.1155 +242 2 12.703 0.102298 5.56963 3.89465 4.4637 5.13268 +243 2 13.2939 17.6289 6.50758 1.00889 22.2284 -14.4481 +244 1 0.327324 2.56344 0.113251 1.70035 12.7901 -0.992224 +245 2 18.009 2.52214 18.5736 8.63965 15.9711 4.89881 +246 2 0.724331 3.48299 0.160564 -21.1536 -24.6374 0.514976 +247 1 12.6396 10.9599 9.76875 -56.8672 19.3176 -11.2335 +248 2 11.6552 10.7306 9.75031 35.1307 23.7735 -5.55284 +249 2 12.944 10.1383 10.0842 27.9729 -33.5927 10.4043 +250 1 0.789377 12.2851 11.08 11.4395 6.49483 14.2632 +251 2 18.4919 12.3017 11.2021 -18.2818 -3.30898 -6.09679 +252 2 1.09088 12.7637 11.8722 5.75277 -12.0493 -6.6955 +253 1 5.04567 7.2193 13.4912 -21.0137 -4.20407 -15.1033 +254 2 5.59899 7.84649 13.0247 8.33052 12.0635 4.31379 +255 2 5.48047 6.97898 14.3058 12.3979 0.954472 8.53674 +256 1 1.28609 6.99027 11.837 -51.8154 -68.8711 -15.2848 +257 2 0.481329 7.14037 11.2978 13.8945 0.267944 10.341 +258 2 1.71601 7.79102 11.8803 31.2664 60.1884 9.92158 +259 1 15.4442 9.46712 12.3088 17.5832 34.764 29.4487 +260 2 15.6103 10.4448 12.4444 -11.1607 -30.7672 -13.8763 +261 2 15.5582 9.10301 13.208 -6.74487 -0.409264 -16.2653 +262 1 16.6404 12.9744 5.44078 0.476019 -21.9889 6.56196 +263 2 16.2955 13.8866 5.54247 3.20084 -14.9841 -16.6056 +264 2 16.51 12.593 4.54035 -6.85686 22.0547 12.2483 +265 1 6.17495 10.0683 0.210584 -24.8048 -7.78292 -31.6597 +266 2 5.35839 10.4511 0.557392 3.36584 -0.936069 -2.46609 +267 2 6.76092 10.0813 0.943985 27.7338 0.90169 16.297 +268 1 12.3644 6.05734 4.04236 -18.3706 -38.3329 30.2118 +269 2 12.4738 6.70802 3.38308 -4.23006 32.9396 -25.2938 +270 2 11.4212 5.77124 4.03221 17.6012 8.78206 -0.800798 +271 1 0.124733 12.8266 0.203961 3.20067 -1.28022 -4.47052 +272 2 0.029974 13.5935 0.786871 -4.13202 -3.19163 0.984476 +273 2 18.185 12.9963 18.0877 7.32574 2.49628 4.77591 +274 1 3.83931 18.5785 8.61972 20.3146 -6.32916 -11.386 +275 2 3.58625 18.36 7.70531 -8.03976 -3.33875 5.01892 +276 2 3.07994 0.282626 9.06556 -19.534 7.19375 -0.404578 +277 1 7.37599 17.2741 4.45241 46.8945 31.0513 1.9622 +278 2 8.02493 17.9603 4.76808 -26.2103 -24.7083 -3.79352 +279 2 7.47725 17.3636 3.49301 -14.0292 -8.10987 6.13371 +280 1 9.20909 17.0315 12.2197 40.0448 -1.21715 18.2255 +281 2 9.48765 16.172 11.8421 -14.9023 11.2095 -3.08284 +282 2 9.99892 17.2887 12.7762 -22.6762 -6.36186 -10.9913 +283 1 13.3284 13.0292 7.94175 -54.0325 -32.963 -10.3586 +284 2 13.0533 12.253 8.47808 14.6554 7.99008 1.85075 +285 2 14.1985 13.2855 8.14946 35.8516 11.3519 14.341 +286 1 14.9871 2.94126 15.3478 14.8638 12.3357 -7.44451 +287 2 14.2243 2.52816 14.9303 4.35222 -7.49481 -2.56315 +288 2 15.7054 3.02501 14.6718 -19.1947 -5.47381 11.1555 +289 1 9.85637 15.4939 17.0026 4.34281 7.61827 -6.92944 +290 2 10.2013 14.6312 16.7411 4.19591 2.79737 -1.68983 +291 2 9.35728 15.3668 17.8085 -9.66212 -2.87408 7.84053 +292 1 11.2848 8.23994 16.5492 3.25751 34.7591 1.5155 +293 2 10.8315 7.75123 15.8747 -12.3664 -15.1549 -6.58201 +294 2 11.7506 7.62533 17.1016 5.33248 -14.8245 8.28699 +295 1 3.77097 18.1898 16.7118 4.01905 33.5947 11.0152 +296 2 4.24576 17.6768 17.3569 8.65949 -22.0954 6.28955 +297 2 3.7978 0.441972 17.1008 -4.25038 -14.6471 -12.4326 +298 1 2.20581 4.09889 8.95874 2.08991 2.93543 4.28652 +299 2 3.00197 3.55544 8.74643 -14.7124 14.9899 14.3923 +300 2 2.10364 4.24367 9.94001 10.2614 -16.6264 -23.5165 +301 1 9.9196 10.3581 9.75231 -25.3187 14.4865 -18.1673 +302 2 9.34403 11.1055 9.40387 23.5511 -18.6954 16.391 +303 2 9.87032 10.282 10.7171 2.48436 10.3271 -7.39297 +304 1 9.73405 0.807167 10.8572 20.2474 21.386 4.54274 +305 2 9.58177 18.5811 11.2204 -17.7151 -14.7389 -0.277185 +306 2 9.10878 1.03014 10.1675 -11.7891 -3.63679 -6.29284 +307 1 9.18221 15.2247 10.2123 -13.9791 -9.46207 -17.3808 +308 2 9.04674 16.0847 9.7631 0.486754 -17.6411 9.75771 +309 2 8.3908 14.6843 9.94105 18.1048 12.7648 16.7376 +310 1 1.00316 9.27987 10.329 16.2357 -30.0069 -12.307 +311 2 1.16727 10.1904 10.5724 12.5584 13.4462 -0.132091 +312 2 1.84996 8.76119 10.1498 -29.1191 35.4904 9.82697 +313 1 16.8004 4.89338 8.19813 20.3933 -12.8673 28.5682 +314 2 16.1748 5.31624 8.83318 13.8703 -8.22156 -17.3769 +315 2 17.4877 4.38941 8.71628 -28.7666 17.1718 -13.9408 +316 1 14.6379 14.6893 0.402347 -11.3933 -1.08114 12.583 +317 2 14.9609 15.3376 1.05877 1.73558 -10.8431 -5.12344 +318 2 13.9048 14.1906 0.841144 16.133 14.0369 -13.7985 +319 1 3.51181 11.0525 9.63829 3.71178 7.51059 -9.42611 +320 2 3.41507 11.3617 10.5484 4.21267 3.5616 -2.2445 +321 2 3.25155 11.8076 9.06383 -1.86739 -11.3951 3.16022 +322 1 11.0289 10.8695 1.26208 17.5529 18.9634 -6.32419 +323 2 11.1535 11.716 0.753779 -2.53448 -25.7082 13.9861 +324 2 10.1142 10.5923 1.16471 -5.76816 1.63272 -1.45278 +325 1 13.2239 7.06188 12.8977 -31.5053 10.0751 -2.41927 +326 2 14.1381 6.84046 12.8922 27.4331 -7.40558 0.979603 +327 2 12.7471 6.22139 12.9668 2.74296 5.12722 -5.48309 +328 1 9.62584 1.88878 0.937813 20.2039 -2.98483 37.6532 +329 2 8.77484 2.11506 0.623903 -27.5663 2.83673 -14.773 +330 2 10.1764 1.70882 0.191067 9.03311 -1.803 -18.3794 +331 1 10.6054 13.537 4.7508 -5.88392 -4.211 -2.61457 +332 2 11.3208 12.9359 5.04367 -2.43279 15.5075 -5.53386 +333 2 10.4128 14.1619 5.47507 10.6777 -11.2442 -5.71889 +334 1 14.2525 1.6915 10.8868 22.6682 20.2673 6.9187 +335 2 15.0842 1.26497 10.6465 -0.175006 -8.05208 -4.1062 +336 2 14.5069 2.62992 10.8824 -12.4791 -0.486299 1.09093 +337 1 14.6678 12.4248 11.7157 -13.2082 -11.6835 -6.16669 +338 2 15.5574 12.5766 11.3177 -21.8957 -10.6844 -5.73724 +339 2 14.0022 11.9667 11.1187 29.6297 15.7618 7.64488 +340 1 8.24065 5.08218 9.78509 -6.47861 44.5837 29.4664 +341 2 7.45364 5.10173 10.3836 14.047 -11.9893 -18.2698 +342 2 8.36822 4.22882 9.41503 -9.58488 -33.9934 -8.19516 +343 1 1.59893 16.8132 18.3262 1.96117 45.1636 -18.3395 +344 2 1.99225 17.1675 17.4932 -11.7114 -3.37836 17.8399 +345 2 1.72693 15.8931 18.2458 8.8364 -33.8164 2.61771 +346 1 1.43382 17.2563 15.3383 72.5903 -10.7327 -13.0674 +347 2 1.32309 18.1562 15.5759 -7.01853 28.114 11.2541 +348 2 0.623143 16.841 15.3782 -65.0193 -20.0106 1.99827 +349 1 3.73599 5.55499 6.2196 -15.153 37.171 -3.6345 +350 2 3.32092 6.26594 6.76194 -0.427016 -18.6419 -6.59332 +351 2 4.19567 6.05321 5.52665 9.16489 -2.39818 -0.177123 +352 1 12.357 9.41487 14.1826 14.7553 -23.0333 -0.513454 +353 2 12.9591 8.63784 13.9021 -31.7094 29.7183 13.6876 +354 2 11.936 9.15457 15.0346 15.6336 0.764049 -11.787 +355 1 4.0362 15.2647 6.90572 29.1452 22.7898 -8.55589 +356 2 3.45744 16.0249 6.7945 -6.03593 0.633302 -6.25525 +357 2 4.92941 15.6518 6.66696 -24.7672 -22.8121 8.07817 +358 1 0.606517 8.56128 14.8606 8.16327 11.3924 -6.42857 +359 2 0.498099 9.52604 14.9437 -1.3098 -5.53798 5.35752 +360 2 1.28855 8.50016 14.167 -7.84877 -5.15776 5.22176 +361 1 12.9763 8.3683 10.3434 -0.844759 8.90572 -31.1716 +362 2 13.7163 7.90436 9.89822 -4.62341 -2.31264 17.3373 +363 2 12.9003 8.0957 11.2534 8.39581 -13.8091 14.665 +364 1 15.2983 7.63672 3.47583 -36.1974 -22.3868 30.0346 +365 2 14.5024 7.10501 3.29647 15.8969 13.8763 -24.8874 +366 2 15.2922 7.47095 4.43335 27.1257 13.219 -1.62631 +367 1 17.3208 6.63818 0.028906 -14.8751 21.4285 -7.11338 +368 2 16.7479 6.05403 0.554933 2.23596 0.744461 -7.2242 +369 2 16.7141 7.27151 18.2009 9.57247 -21.991 17.917 +370 1 8.79355 6.92545 7.84172 -22.0329 -24.5159 21.3067 +371 2 9.63968 7.32585 7.85068 36.717 16.3192 -5.46325 +372 2 8.77688 6.39871 8.67404 -5.56167 6.19415 -17.3543 +373 1 12.3209 0.607808 1.1741 -8.60043 -0.59496 -5.94607 +374 2 12.995 1.15082 1.58835 11.0262 -7.11766 4.69751 +375 2 12.79 18.5825 0.66073 -1.01688 3.73434 3.9163 +376 1 5.68514 15.097 14.5145 8.08213 26.2607 -13.8654 +377 2 4.72797 15.1695 14.4772 -8.65505 -1.66018 8.38379 +378 2 6.02476 15.8935 14.032 -4.56821 -16.9623 16.8148 +379 1 3.822 6.53853 1.67803 10.5239 -7.29529 -10.476 +380 2 3.54968 7.33117 1.17576 -0.94291 -9.86176 19.1013 +381 2 3.81642 6.7886 2.60252 -1.1437 7.90849 5.70077 +382 1 3.89262 11.6088 12.227 12.6183 0.535598 5.61903 +383 2 4.72051 12.1032 12.348 1.21499 -6.42147 -0.654839 +384 2 3.26281 12.0921 12.7526 -15.9809 8.56892 5.74885 +385 1 5.45444 3.88172 15.8755 8.44756 62.1439 23.7417 +386 2 5.90627 3.24049 15.3708 26.1603 -31.2362 -14.1171 +387 2 6.11665 4.65725 15.9739 -35.5554 -35.0069 -5.06549 +388 1 14.4636 10.317 4.39501 5.54347 -18.2961 -43.8287 +389 2 14.9051 9.88853 5.13417 0.162303 -5.91623 3.64337 +390 2 14.7084 9.81768 3.53446 -11.8135 21.0668 42.8202 +391 1 7.94949 17.2895 9.24469 -10.6799 8.8199 -1.02562 +392 2 7.23447 17.5423 9.86969 8.35341 2.50468 -15.9799 +393 2 8.01085 17.8889 8.47627 -8.2125 1.31495 9.33291 +394 1 4.4986 14.4237 3.96317 23.4879 4.54475 27.495 +395 2 4.89523 15.3318 4.14709 -14.6852 -27.1979 0.729547 +396 2 4.80237 13.7713 4.67129 -11.1841 28.5155 -20.9146 +397 1 14.3358 7.38467 15.7635 18.2582 5.36164 1.70543 +398 2 15.2401 7.23754 15.391 -25.5283 4.5174 14.2628 +399 2 14.4998 7.83446 16.6232 -7.00614 -11.7321 -15.3353 +400 1 2.86875 18.2246 1.90934 11.7547 29.7641 47.6357 +401 2 2.54447 17.7626 1.17928 -20.4445 -34.8995 -41.4626 +402 2 2.08284 18.4154 2.45796 12.4063 3.86937 -8.17484 +403 1 7.96139 1.61197 4.52525 30.3503 -5.61589 29.1814 +404 2 7.4985 1.83317 3.72811 -5.85178 12.6793 -14.6648 +405 2 8.84188 2.051 4.57628 -22.8061 -6.44347 -10.2559 +406 1 2.69247 14.1251 17.7583 -44.9975 -8.30966 9.027 +407 2 1.78944 13.8074 18.0556 29.9332 0.951363 -12.1679 +408 2 3.33089 13.517 18.1683 -0.885538 6.08231 -6.55793 +409 1 0.711797 1.68055 13.8626 46.1903 -0.903658 -18.4125 +410 2 0.854596 1.56791 14.7929 -3.1534 -4.53792 18.4431 +411 2 18.4557 1.86826 13.7064 -36.4408 7.03813 3.66844 +412 1 4.5582 18.5986 13.9691 16.7448 -5.62304 -20.7496 +413 2 5.37614 18.0918 13.7297 -17.5024 17.6116 13.2075 +414 2 4.4096 18.4453 14.9034 -5.9637 -5.97884 8.59903 +415 1 7.10973 0.453475 18.3742 -15.9095 45.4284 35.234 +416 2 6.99644 0.098599 17.5235 1.36411 -17.312 -40.4978 +417 2 6.34312 1.05085 18.5323 11.251 -17.9428 -0.916775 +418 1 16.0934 18.4421 14.1505 -12.1616 -21.5095 -38.715 +419 2 15.444 17.7866 13.7542 19.2119 24.6311 23.4234 +420 2 16.0379 18.4915 15.109 -11.392 0.0248185 1.48898 +421 1 10.1156 4.52417 16.2956 -62.1497 -10.7811 -30.3439 +422 2 10.9808 4.34247 16.5381 55.5233 -0.530433 19.4573 +423 2 9.84863 3.69679 15.8473 1.30878 12.8229 10.5952 +424 1 15.8226 17.9425 4.41327 -8.6596 2.53656 28.4341 +425 2 16.5547 18.5732 4.53052 -7.53986 -1.28134 -1.76301 +426 2 15.1071 18.2295 5.06915 24.8326 -13.5436 -35.3744 +427 1 6.9246 17.3574 13.7412 35.4232 12.1969 -4.79491 +428 2 7.49648 17.8115 14.4369 -19.095 -19.6264 -17.6052 +429 2 7.52703 17.1963 12.9658 -8.44681 6.90552 21.4872 +430 1 13.2892 6.57209 6.73437 -47.4462 -6.01427 11.894 +431 2 14.2146 6.66317 6.83486 37.5911 0.460957 -13.6759 +432 2 13.0394 6.38579 5.82242 8.60231 0.411312 -6.48828 +433 1 7.6616 2.3861 9.17526 11.1339 -5.58665 -35.6695 +434 2 7.32169 2.39592 10.0555 -17.0215 -5.04529 20.6135 +435 2 6.95914 2.1022 8.53308 18.7558 7.43711 21.2842 +436 1 15.1464 14.8771 13.6482 -7.73724 1.21311 0.537171 +437 2 15.0308 15.0223 14.6069 -1.84691 1.26092 -11.2626 +438 2 14.3194 15.1152 13.1798 14.9291 -3.65447 11.731 +439 1 9.29105 8.34315 3.70472 21.3149 -22.535 5.81715 +440 2 10.1776 8.75859 3.73678 -10.082 3.55323 2.49013 +441 2 9.48378 7.39942 3.88081 -6.26995 14.6936 -2.40173 +442 1 17.6854 13.4687 16.4528 7.27147 30.461 -18.2669 +443 2 16.7357 13.4337 16.3398 -4.89197 -8.49248 4.47316 +444 2 17.8844 14.3284 16.0065 3.65909 -18.1112 10.9221 +445 1 5.04883 10.6547 2.58751 22.4142 -14.5409 3.1837 +446 2 5.87017 10.3468 3.04382 -22.783 5.18619 -3.79272 +447 2 4.55197 11.1441 3.22928 -6.35653 9.92745 13.9967 +448 1 3.70566 8.3683 10.3381 0.421872 -35.3081 -1.7593 +449 2 3.86061 9.29726 10.2176 3.60826 23.2513 -1.90293 +450 2 3.86652 8.14601 11.2715 -1.83662 8.64514 -7.63686 +451 1 16.1079 7.11641 6.33859 18.7251 -13.7954 -9.96454 +452 2 16.7241 7.70559 6.80408 -7.87205 -5.85527 -7.24175 +453 2 16.6678 6.33083 6.12136 -22.8952 10.0887 6.36104 +454 1 15.2027 7.00502 9.1117 -13.5711 31.2066 -33.9348 +455 2 16.009 7.42176 9.46585 -10.2898 -7.03399 -7.73296 +456 2 14.9881 7.51375 8.25647 13.8068 -20.3115 41.0185 +457 1 6.4525 13.1649 12.9201 -16.9811 1.25576 1.12717 +458 2 7.2977 12.7289 13.0561 1.55279 -4.02118 8.73008 +459 2 6.25327 13.7237 13.7059 9.12735 -9.15034 -19.1848 +460 1 12.1145 4.49786 13.0694 62.3048 41.2439 -0.723073 +461 2 12.3852 4.68406 13.9868 -14.3297 -10.0558 -0.292641 +462 2 11.3952 3.9317 13.0199 -52.2119 -35.1204 4.15665 +463 1 11.3323 8.18365 7.8522 27.7169 3.03613 12.328 +464 2 12.0901 7.73501 7.43634 -12.9205 -4.29619 -7.69129 +465 2 11.7651 8.45102 8.68662 -18.4456 -0.736999 -3.04515 +466 1 17.1666 10.776 7.42179 36.4822 -17.3878 -25.363 +467 2 17.7906 10.0723 7.08441 -17.5934 13.4566 22.3886 +468 2 17.2793 11.4524 6.73733 -15.3427 2.84073 7.18141 +469 1 5.22802 18.1471 11.05 -23.1388 -14.8798 2.48444 +470 2 4.73762 18.1049 11.901 7.4508 0.565766 -17.6495 +471 2 4.62535 17.7417 10.374 17.7336 12.8347 12.9373 +472 1 7.56653 17.6363 1.80821 4.35794 -3.26776 57.5888 +473 2 7.65741 16.7768 1.42856 9.05039 -19.6913 -22.9027 +474 2 7.35855 18.2549 1.13994 -1.37991 13.1573 -30.1972 +475 1 1.85092 12.9256 13.6076 18.7065 20.702 19.2299 +476 2 1.72104 12.4156 14.4258 -5.54537 -0.960406 -11.4426 +477 2 2.19932 13.7866 13.9501 -8.88955 -22.8153 -6.43965 +478 1 9.73868 6.79159 14.8001 -20.0718 45.6966 0.235719 +479 2 9.95236 5.95211 15.1529 12.0129 -40.6355 11.2206 +480 2 9.967 6.84408 13.8723 5.59208 -5.10263 -8.66058 +481 1 15.2087 4.3972 10.7794 -27.6923 -26.0969 -27.5028 +482 2 16.0082 3.89203 10.8637 26.1176 6.2885 5.33656 +483 2 15.2102 5.16148 11.3322 8.48984 16.211 19.3779 +484 1 11.1963 6.12482 0.150068 -21.1972 -23.7011 14.8212 +485 2 11.2381 5.20796 0.481504 11.4486 12.9471 -10.1704 +486 2 10.2374 6.21547 18.6186 14.0424 14.8346 -3.67395 +487 1 0.19533 11.3359 15.1413 -20.6703 11.3325 -28.7309 +488 2 18.4021 11.874 14.3993 9.91215 -19.3636 27.3138 +489 2 18.4481 11.661 15.9631 4.36494 9.01906 -3.16307 +490 1 7.06882 9.13032 7.26059 -19.4655 -1.24154 14.8953 +491 2 6.55985 8.40099 7.69941 12.6354 16.9737 -16.1687 +492 2 7.9725 8.82922 7.21375 8.43039 -5.65083 0.275054 +493 1 18.4578 15.4507 12.3537 3.87705 -1.0699 -4.92487 +494 2 0.776651 15.5698 12.2511 -12.7177 -2.03387 6.80581 +495 2 18.1456 15.6789 11.4721 -4.67377 -0.406651 0.743757 +496 1 16.5694 4.36967 5.25107 0.98709 -29.8421 42.9348 +497 2 16.7744 3.81151 6.06026 -19.0257 27.4778 -23.1846 +498 2 17.3898 4.32671 4.78168 15.572 7.21618 -21.1326 +499 1 17.788 3.06911 10.7078 7.64381 16.9425 17.2861 +500 2 0.075758 3.1322 11.0257 -14.4921 -2.82201 -9.29777 +501 2 17.6332 2.20749 10.3226 4.29805 -13.9207 -6.70838 +502 1 12.3142 0.064083 10.1758 -16.2036 46.6093 2.93236 +503 2 11.3746 0.384648 10.259 24.7548 -16.9496 1.0795 +504 2 12.8178 0.919304 10.3228 -10.1981 -36.9052 -8.89593 +505 1 10.3666 9.83315 12.2981 10.0643 6.74252 24.9843 +506 2 11.1015 9.85063 12.955 -7.48254 2.69098 -11.3777 +507 2 10.1328 8.91188 12.2898 -1.25875 -17.3524 -2.69444 +508 1 0.463654 2.82678 7.01839 23.1504 30.9543 10.494 +509 2 0.875324 3.58845 7.48211 -15.8261 -9.71426 -11.3384 +510 2 0.770257 2.12665 7.58365 -2.51696 -19.6875 3.88184 +511 1 0.478371 15.2358 6.91004 -5.36214 -57.1351 9.88058 +512 2 0.585298 15.6463 7.75647 2.33624 13.0536 15.0713 +513 2 0.556531 14.2524 7.18353 -2.6234 48.5984 -27.3232 +514 1 16.9534 7.00251 15.3394 -19.8576 7.98442 -8.98385 +515 2 17.6338 7.63543 15.0899 18.202 -5.57661 4.9227 +516 2 17.3093 6.19568 15.7235 12.2576 0.0838452 -6.46227 +517 1 9.0001 12.4151 8.13768 -31.7276 34.3494 27.7642 +518 2 9.37386 11.8218 7.49742 -2.69042 -17.0115 -24.8182 +519 2 8.02402 12.632 8.03373 37.271 -17.4326 -7.14384 +520 1 1.27238 1.95406 3.05803 -14.2139 -9.70678 -17.9319 +521 2 1.26084 2.61511 2.34121 0.72572 -7.36998 11.1944 +522 2 1.89031 2.22344 3.73293 7.71835 10.2015 -2.21509 +523 1 4.13907 15.1156 9.62039 -24.138 8.67184 14.727 +524 2 4.07003 15.1439 8.65747 7.76366 -2.53025 0.663124 +525 2 4.96029 14.7006 9.86457 16.019 -6.11163 -3.79055 +526 1 7.17628 2.17866 14.5671 8.05543 15.8774 -0.750343 +527 2 6.99528 1.68402 13.7698 -4.08254 -5.57585 -6.74919 +528 2 7.62131 2.98432 14.249 -3.31184 -9.11349 9.13274 +529 1 18.6082 14.7131 2.1481 32.1263 -19.3615 -2.59353 +530 2 0.838003 15.1297 2.25966 -2.55576 -5.62694 -3.02712 +531 2 17.988 15.3544 2.42675 -29.4597 23.3621 5.14018 +532 1 9.94138 2.79524 12.9422 18.0301 -20.084 -2.65944 +533 2 9.79404 2.1456 12.2228 -2.72579 10.1868 5.0837 +534 2 9.17835 3.36299 13.0326 -9.76513 7.42125 -6.32672 +535 1 2.80444 8.90955 13.0076 -21.3878 -12.6555 -0.633582 +536 2 3.06361 9.80599 12.872 11.8276 24.8177 -4.92621 +537 2 3.5122 8.48618 13.4775 16.8101 -10.8298 6.5617 +538 1 3.236 8.3574 3.63664 -3.24123 -25.7508 65.6997 +539 2 3.45085 9.0718 3.07326 14.699 31.6407 -15.7982 +540 2 3.47645 8.58669 4.60794 -10.8292 -3.55345 -46.4885 +541 1 5.62853 7.18594 8.51094 13.0444 23.9613 2.26298 +542 2 5.46784 6.31815 8.13889 -4.11832 -12.799 10.1434 +543 2 4.96415 7.47792 9.15047 -6.22666 -11.1251 -0.517113 +544 1 14.8757 1.26039 2.01768 6.89853 7.12439 -27.6668 +545 2 14.9353 2.01952 2.56559 -6.08088 15.4811 28.5729 +546 2 15.2784 1.60993 1.21235 -3.12956 -15.001 -5.59525 +547 1 8.22892 15.2012 0.850139 9.01324 -8.86779 5.43529 +548 2 9.02213 14.9338 1.33488 4.41045 13.1537 -1.08033 +549 2 7.55366 14.6663 1.27665 -10.9347 0.418265 -6.06235 +550 1 15.6387 1.34587 7.23673 -34.4855 -14.424 -6.72803 +551 2 14.9277 0.724731 6.91269 25.2779 16.6902 6.4887 +552 2 15.1173 2.1119 7.53894 8.3028 -0.775331 -5.89355 +553 1 4.90142 13.0959 18.5232 17.5611 -6.682 24.5871 +554 2 5.32755 13.082 0.76977 -9.23128 1.69535 -18.7742 +555 2 5.44764 13.7122 18.0259 4.92611 -3.73779 -6.82361 +556 1 15.3368 8.46948 18.1479 24.407 23.6523 -18.6734 +557 2 15.8061 9.12264 17.5623 -15.0725 -19.5419 9.94084 +558 2 15.3318 8.91689 0.353875 -7.67765 1.6761 7.06822 +559 1 12.0708 3.01842 18.3809 -8.57811 34.9919 -15.9288 +560 2 11.9316 2.65996 0.60646 7.37996 -15.8634 5.79137 +561 2 12.6022 2.47389 17.7995 4.55547 -17.8211 5.72515 +562 1 13.2139 12.6752 5.17768 -11.8856 9.18106 -10.9384 +563 2 13.7464 12.0348 4.69253 2.29692 -7.56952 8.05888 +564 2 13.2564 12.5123 6.11793 11.0077 -2.72782 9.02039 +565 1 6.05443 7.0356 0.031519 0.145276 -19.8641 5.27909 +566 2 5.93935 7.95118 18.5019 2.68887 36.361 -1.99394 +567 2 5.39095 6.86665 0.702638 -10.5375 -11.3291 0.555603 +568 1 17.7528 16.0276 15.0213 -26.9751 8.08167 9.65398 +569 2 16.9476 16.5457 15.105 2.62193 -2.13449 20.9775 +570 2 17.7479 16.0055 14.0813 23.0391 -15.2709 -33.7916 +571 1 13.196 0.994907 16.5363 6.64944 3.5152 15.0268 +572 2 14.1481 0.997912 16.7614 -13.0846 -5.94027 -6.50206 +573 2 12.8833 0.094199 16.7238 3.13951 3.25376 -8.62791 +574 1 11.1253 14.5647 7.20271 12.6179 20.8985 -18.374 +575 2 10.4007 14.3183 7.72981 -32.928 -10.0181 24.5345 +576 2 11.7186 13.8255 7.26943 16.9686 -3.76464 3.70387 +577 1 17.5081 8.62849 2.08107 18.4536 39.9223 21.5452 +578 2 16.6801 8.63471 2.55495 -14.8656 -12.3201 1.9096 +579 2 17.5233 7.88242 1.516 -5.44609 -31.2556 -23.2052 +580 1 12.3547 8.01168 2.02213 3.34817 7.10659 0.607451 +581 2 12.2384 8.8582 1.54611 -2.17098 -11.1853 7.9144 +582 2 11.9739 7.3152 1.48261 -5.38076 0.52639 -15.2068 +583 1 11.8761 14.6165 10.3364 1.47614 -26.5661 -12.796 +584 2 12.1004 13.7873 9.81464 -15.4397 33.1565 21.8304 +585 2 10.8993 14.6888 10.473 20.8283 -4.95583 -12.7008 +586 1 6.89524 7.05211 15.6117 0.948881 6.37495 10.6055 +587 2 7.81004 7.26536 15.3122 -15.6925 -0.985911 8.93516 +588 2 6.66676 7.54167 16.4408 13.3623 -9.35483 -24.2683 +589 1 8.00326 4.73593 13.4743 46.4542 16.9938 22.3473 +590 2 7.23337 4.7302 12.9572 -38.0428 3.58552 -28.1525 +591 2 8.40671 5.62958 13.343 -10.0413 -24.497 3.68285 +592 1 13.4128 12.1818 14.2522 -5.09814 -0.706424 13.2965 +593 2 12.9414 11.3292 14.2657 9.08717 -0.174959 -7.02282 +594 2 13.7875 12.315 13.3696 0.74786 -2.13255 -0.749325 +595 1 14.8395 9.42189 7.30548 -8.6508 -34.4179 -15.7659 +596 2 15.7087 9.765 7.42505 16.3683 18.0856 5.12693 +597 2 14.2269 10.0768 7.57319 -16.6679 19.7312 11.3719 +598 1 12.6526 17.0686 3.07252 -27.098 39.8252 10.9251 +599 2 12.8376 17.5237 3.93373 4.63929 -18.9198 -22.9156 +600 2 11.9913 17.6958 2.63477 30.4514 -31.1971 13.898 +601 1 1.15545 7.13838 17.4647 3.17244 9.59861 -23.4243 +602 2 0.330359 7.36323 17.9184 0.96629 -9.78644 0.159833 +603 2 1.05514 7.47868 16.5422 0.732192 -3.11516 17.9471 +604 1 12.7562 5.15096 15.6457 43.4314 -6.34677 13.892 +605 2 13.4512 4.55662 16.0315 -22.7809 11.2033 -14.7919 +606 2 13.2414 6.00335 15.5788 -11.6166 -6.13865 2.23982 +607 1 2.53993 3.38757 4.97618 -22.6627 40.6834 48.2045 +608 2 1.7609 3.18232 5.58922 26.9518 1.19035 -20.1247 +609 2 2.84154 4.31546 5.27885 -5.90416 -46.089 -11.2441 +610 1 8.33186 11.2983 13.4548 -26.6082 5.68838 43.1719 +611 2 8.4244 11.0562 14.4444 7.75654 0.873515 -50.9507 +612 2 8.91168 10.8786 12.8197 22.3442 -13.0535 12.4472 +613 1 12.8689 1.31514 13.3384 2.90045 58.5941 -12.9641 +614 2 13.42 1.58034 12.5659 -7.54964 -19.9936 10.3698 +615 2 12.4231 2.17844 13.5496 8.73522 -32.0886 -3.11014 +616 1 6.34008 13.7169 2.14963 -18.1698 -8.87317 18.5321 +617 2 5.63978 13.877 2.82959 15.2612 6.49493 -20.3543 +618 2 6.88351 13.0442 2.56282 10.2537 -4.17084 0.110729 +619 1 15.9206 6.61444 12.7992 -24.6515 -28.5257 0.353752 +620 2 16.3106 7.25195 12.2393 18.8127 19.5603 -18.6955 +621 2 16.4213 6.59661 13.608 8.17022 1.84551 14.3752 +622 1 16.8298 0.712824 9.59482 4.92561 -19.6459 1.56363 +623 2 16.8791 18.3713 9.72616 -6.7933 22.7031 -2.37673 +624 2 16.5452 0.8605 8.67269 -3.47063 -2.57745 5.28583 +625 1 6.14624 11.7631 8.37671 0.810232 -55.5778 6.71556 +626 2 5.32447 11.4591 8.84151 13.2611 12.3623 -11.7456 +627 2 6.64226 10.8931 8.20176 -18.8432 36.5086 0.169281 +628 1 2.88754 8.61261 0.453821 16.629 -12.4076 -25.9584 +629 2 2.45212 8.04764 18.3917 -7.9132 30.8844 23.5565 +630 2 2.34875 9.28564 0.895642 -16.9187 -4.58083 -11.1609 +631 1 10.1674 10.4623 6.50123 2.03347 0.962837 -14.0367 +632 2 10.6087 9.69731 6.89122 -0.033473 -1.16532 5.68604 +633 2 10.4694 10.4636 5.56932 -4.02396 0.831062 14.2442 +634 1 6.7142 15.6951 6.55167 21.2433 7.58031 13.0519 +635 2 7.14328 16.1838 7.27089 -7.64643 -7.38759 2.93585 +636 2 7.21237 16.006 5.79102 -10.2318 7.90387 -13.7372 +637 1 6.445 13.1807 5.57797 -4.95716 -23.6388 -1.26087 +638 2 6.7301 13.9465 6.07331 -1.77634 9.04977 6.94523 +639 2 6.09943 12.5433 6.22286 1.34041 6.33507 -0.553394 +640 1 16.8242 12.5629 9.83758 4.06472 -20.7324 4.78658 +641 2 16.9985 11.8651 9.16533 -5.27225 15.8277 3.76725 +642 2 16.5644 13.3844 9.42716 1.03985 5.07871 -11.9 +643 1 6.03738 2.95058 2.86354 -7.03855 -25.5492 -1.19629 +644 2 6.40977 3.757 2.57075 15.9289 34.7492 -4.17594 +645 2 5.57703 2.61747 2.09059 -4.9021 -9.32473 -6.53819 +646 1 10.9114 3.33767 3.30112 5.22699 -4.50477 6.26496 +647 2 10.297 4.02722 3.58926 -1.95634 -6.20434 -4.73409 +648 2 10.5127 2.84524 2.57795 -5.80356 2.60284 -4.41077 +ITEM: TIMESTEP +10 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.68613 7.08001 17.9478 -7.01358 -5.91592 2.73538 +2 2 7.77987 6.83016 18.2266 16.0785 4.58355 -9.56375 +3 2 8.81561 6.77572 17.042 -2.60158 -2.67368 4.89818 +4 1 18.5411 8.25019 6.8397 -3.31911 20.0829 53.2463 +5 2 0.132112 7.95881 5.98338 15.0803 -17.7916 -37.9407 +6 2 0.419079 7.77779 7.52768 -3.57438 0.834533 -17.4022 +7 1 8.38502 18.5543 6.8162 17.8503 9.74549 -0.663478 +8 2 9.33656 0.12202 6.71165 -15.3958 -3.25669 1.14423 +9 2 7.91896 0.595612 6.31609 0.0971505 0.0480551 2.20998 +10 1 6.59239 1.84347 11.7106 33.6248 -3.3918 -11.5419 +11 2 5.88602 2.36507 12.0365 -24.0057 14.4643 13.3031 +12 2 6.19621 1.03555 11.4016 -9.54455 -15.1367 -3.43817 +13 1 7.13469 5.75647 2.33282 -16.0707 1.2807 18.6339 +14 2 6.47472 6.10605 3.02238 22.3175 -2.25238 -34.2201 +15 2 7.09016 6.23688 1.47486 -10.0175 -2.52095 21.7818 +16 1 16.2156 10.1493 16.1334 -27.9935 4.46583 14.8083 +17 2 17.0011 10.2168 15.6173 19.2784 7.57164 -10.1711 +18 2 15.8457 11.0427 16.2776 9.29404 -6.61316 -4.9073 +19 1 10.6069 15.0238 2.30809 -6.31705 -20.7544 -7.43742 +20 2 10.5597 14.4327 3.07214 -0.102442 0.508968 4.74876 +21 2 11.0526 15.7982 2.62807 10.1844 15.1967 6.36644 +22 1 17.1594 8.2489 10.3903 7.52685 0.546464 5.9579 +23 2 16.5819 8.79937 10.9325 -0.0424193 4.91704 3.34034 +24 2 17.9857 8.74574 10.257 -6.36369 -4.03495 0.916497 +25 1 14.8922 15.8683 16.3299 23.5339 -10.8154 7.03311 +26 2 14.0097 16.1903 16.2206 -28.4756 7.26009 1.81472 +27 2 14.9055 15.3621 17.1614 -4.45807 1.9077 -0.883551 +28 1 12.1657 13.3863 0.41518 7.67499 -13.0963 13.9948 +29 2 12.1102 13.7181 18.1579 -7.06431 5.66946 -3.72811 +30 2 11.6673 13.9211 1.04936 -4.85696 8.50836 -7.81927 +31 1 9.27628 5.36844 4.05123 -34.192 4.59602 9.65195 +32 2 8.65917 5.24858 4.84371 24.3198 3.71877 -28.2857 +33 2 8.65376 5.51218 3.29446 11.8948 -3.58803 14.2972 +34 1 1.82985 4.27304 11.6494 -12.5424 24.0017 -6.14821 +35 2 1.72713 5.22025 11.9335 1.67264 -20.3932 -8.37626 +36 2 2.38183 3.84857 12.2925 10.2742 -10.1374 14.5925 +37 1 1.96666 6.8371 8.3675 -1.07206 -9.37897 -7.64517 +38 2 2.48137 7.16021 9.09528 7.6819 14.0614 11.7347 +39 2 1.91994 5.89719 8.57067 -2.65468 -6.85216 -5.3032 +40 1 5.40566 4.39875 7.93795 -15.0212 -10.7202 -17.6012 +41 2 5.47911 3.43644 7.82861 5.00513 7.47325 10.3929 +42 2 4.74947 4.60653 7.2496 8.53973 6.88839 10.8311 +43 1 3.24286 2.9209 17.5475 -3.50993 31.6723 15.8788 +44 2 3.91538 3.33593 16.9792 1.14815 -4.85754 -1.50754 +45 2 2.90196 3.68515 18.1088 4.46159 -27.603 -16.229 +46 1 7.46543 5.27113 6.11173 -0.267366 -14.8618 42.036 +47 2 7.89952 5.61794 6.92737 -2.28349 10.3868 -28.0837 +48 2 7.00366 4.5014 6.50229 0.780861 12.0869 -17.1147 +49 1 9.7753 7.01959 11.9799 12.4421 -0.327694 33.7281 +50 2 10.3285 6.37932 11.5448 5.34489 -7.46932 -11.0014 +51 2 9.14168 7.33293 11.3548 -18.5265 5.10994 -23.2436 +52 1 14.1114 3.54906 8.03925 -21.2079 2.70274 -24.764 +53 2 13.5379 4.24737 7.67406 9.42135 -8.95765 0.532077 +54 2 14.4057 3.90023 8.85862 11.8721 11.0917 26.6467 +55 1 4.80077 17.263 4.02669 -14.2573 4.92943 -10.2324 +56 2 5.55275 17.8868 4.11075 -15.7048 -9.31229 -6.31173 +57 2 4.21849 17.485 3.25536 16.798 3.03083 13.1086 +58 1 16.5008 16.6241 10.052 9.35033 0.377019 -20.0251 +59 2 16.0742 16.3966 10.8515 -13.0635 -0.25069 32.9814 +60 2 15.9476 16.1716 9.40786 2.84148 0.00630379 -7.36632 +61 1 1.95698 4.92664 0.48601 10.6785 6.17321 -0.923017 +62 2 2.54546 5.28332 1.19783 -10.1544 -3.94981 -19.1082 +63 2 1.86706 5.64777 18.4726 -0.259245 -4.73099 10.3692 +64 1 11.8035 13.3621 16.2801 -12.0315 -31.2076 -16.8087 +65 2 11.3006 12.5351 16.4295 -1.37085 13.2186 10.8936 +66 2 12.2283 13.1244 15.4353 5.36339 15.8055 8.10642 +67 1 10.1086 11.0623 16.95 16.2363 -23.6439 1.11167 +68 2 10.572 10.1938 17.105 -14.3776 22.5927 -6.24497 +69 2 9.21542 10.8357 16.6616 -0.160324 -0.0991661 2.29857 +70 1 11.7231 17.5369 13.4667 -11.0418 -25.624 2.08744 +71 2 12.2825 16.9797 12.896 1.06573 10.1819 1.6514 +72 2 12.0497 18.4302 13.3866 8.679 12.3703 -3.21063 +73 1 6.34404 9.31427 12.2267 -10.7289 -25.2447 -16.4149 +74 2 6.95388 8.98312 11.5319 -2.39052 10.1346 10.7157 +75 2 6.76108 10.0063 12.722 17.2241 14.9443 4.4156 +76 1 16.2191 12.7237 2.7003 -6.42998 -13.8373 4.3175 +77 2 16.9936 13.1939 2.44509 26.0904 7.71252 -7.79508 +78 2 15.5637 13.4111 2.72948 -20.2851 11.8065 3.04981 +79 1 0.635855 12.5646 5.86231 -29.6975 10.9384 -12.0161 +80 2 0.906184 12.4779 4.92975 2.15237 -1.21985 12.1118 +81 2 18.3245 12.8391 5.75844 29.6273 -11.2198 7.31028 +82 1 5.19222 16.3868 18.4948 24.5889 -0.529385 -6.85369 +83 2 5.88953 15.8781 18.0466 -13.534 -2.69513 -2.10794 +84 2 5.71609 16.8872 0.480999 -10.5805 4.6302 6.45748 +85 1 0.515864 7.62939 4.0653 41.0474 19.9956 -23.6294 +86 2 18.5677 8.05158 3.40199 9.2753 -7.28591 11.0746 +87 2 1.47269 7.84683 3.73678 -46.4137 -9.00167 19.6367 +88 1 3.14217 8.89553 6.52533 -39.0459 6.50689 -6.5056 +89 2 3.57285 8.63007 7.33767 0.0694837 -1.26665 5.56399 +90 2 2.14756 8.93745 6.67407 38.5311 -3.64433 -0.906695 +91 1 7.31414 10.3036 16.1763 -22.1518 3.21861 21.8391 +92 2 6.53268 10.4772 15.6415 8.43374 -0.0418936 -5.11234 +93 2 6.92709 10.2964 17.0866 13.3044 -2.27208 -10.5118 +94 1 11.1096 1.06093 5.00144 -6.80657 -2.48033 -19.8934 +95 2 11.1672 1.90146 4.5306 6.84499 7.0717 9.43568 +96 2 10.7236 0.515071 4.29558 2.64862 -9.02148 12.7331 +97 1 4.44354 2.70015 13.2121 -7.85281 -5.62302 -11.5877 +98 2 4.59136 3.20795 14.0303 0.103412 -15.4758 0.294405 +99 2 4.3686 1.71349 13.3622 2.85998 26.6352 12.1157 +100 1 8.41457 10.0307 1.78829 1.66015 -12.4273 17.1623 +101 2 8.40835 10.6665 2.53096 -1.47245 -0.417386 -5.09881 +102 2 8.60407 9.1525 2.20287 -3.10051 22.5249 -10.5265 +103 1 10.5229 1.75436 15.5533 -10.8574 -2.31 -4.36647 +104 2 11.4367 1.69676 15.8141 13.1269 -3.82494 7.61076 +105 2 10.5487 1.84704 14.5957 -9.26118 2.80358 -1.94415 +106 1 2.76968 12.9399 7.75003 -7.62511 -10.5749 7.18171 +107 2 3.32023 13.5874 7.29614 -2.30989 2.01815 -3.81018 +108 2 2.03946 12.7099 7.15165 5.79412 3.19458 -2.23462 +109 1 3.64251 11.6901 5.3273 -16.0178 -10.9709 -3.95767 +110 2 3.35804 11.041 6.0007 8.31372 10.277 -11.7948 +111 2 2.86611 11.8409 4.75105 13.6859 -0.281218 5.78901 +112 1 6.88155 14.4797 16.8524 -8.387 2.95998 -0.938339 +113 2 7.57426 13.8507 16.6622 5.60788 -2.76391 3.60002 +114 2 6.54738 14.7428 15.9834 -3.14908 -1.19839 3.78249 +115 1 14.1759 14.5423 3.40785 14.1775 -0.803279 -11.9449 +116 2 13.6583 15.316 3.2037 -5.78511 13.0134 -4.56688 +117 2 13.7723 14.1777 4.18517 -7.95121 -12.1195 11.7606 +118 1 8.26975 18.1784 16.0718 57.0984 -9.85256 5.13508 +119 2 8.90468 17.4721 16.3223 -30.0265 -6.05197 -2.08742 +120 2 8.93252 0.246004 16.0158 -21.102 13.2242 -8.22396 +121 1 4.73201 1.6168 4.90814 8.59128 29.3629 -19.7592 +122 2 3.91099 2.13549 5.04668 12.4977 -9.17326 -4.88478 +123 2 5.26431 2.14928 4.23236 -22.3039 -21.7635 28.9569 +124 1 15.1182 12.8405 16.4381 19.169 -3.61406 36.631 +125 2 14.6612 12.9963 17.2965 -1.87916 -0.605635 -21.6052 +126 2 14.5331 12.7051 15.7087 -30.2626 -2.71441 -16.8094 +127 1 15.786 18.3864 16.793 25.1295 13.8681 33.7963 +128 2 16.4578 18.6099 17.5315 -31.6416 -14.5347 -31.3905 +129 2 15.6162 17.4305 16.8164 1.02724 4.80811 3.46398 +130 1 1.14089 1.13731 16.5539 1.05247 19.7088 19.8175 +131 2 1.92337 1.60495 16.9036 -3.97271 -4.80748 -10.3705 +132 2 0.461096 1.48073 17.164 6.66439 -11.1518 -10.5802 +133 1 18.0862 4.58432 15.8734 11.1688 -12.2484 -2.69667 +134 2 18.5694 3.95442 15.2994 -8.21946 11.4291 8.6944 +135 2 18.5872 4.69164 16.6898 0.203498 -2.64567 -2.95902 +136 1 12.2303 16.9505 16.1288 -38.2728 -13.2591 26.8237 +137 2 11.3888 16.5791 16.5378 36.1694 7.82178 -3.50336 +138 2 11.9114 17.1502 15.2549 6.78701 5.10115 -22.4581 +139 1 15.8814 2.54765 17.9709 5.97775 7.55467 -0.319093 +140 2 15.7733 3.43717 18.3784 -1.8513 -17.3861 -11.5789 +141 2 15.6471 2.5946 17.0126 2.53833 6.86428 19.1803 +142 1 6.70799 13.8021 10.253 -1.58408 1.43394 8.76454 +143 2 6.59288 13.5189 11.1728 1.36627 8.87991 1.27306 +144 2 6.58321 12.9942 9.75946 1.30239 -6.02422 -13.3165 +145 1 10.1413 18.2148 2.80353 9.44086 30.3012 -19.3156 +146 2 10.2266 0.305071 2.14691 0.267733 -14.8877 14.3982 +147 2 9.27777 17.8669 2.60695 -13.096 -6.5965 0.845742 +148 1 2.97176 17.7529 6.06326 -6.30899 -0.645097 35.0899 +149 2 2.08427 17.6133 5.69483 9.57331 2.68214 -12.771 +150 2 3.63239 17.8017 5.37586 1.28926 -2.69105 -18.2517 +151 1 12.5668 16.9974 7.96757 -20.2971 -18.5655 21.3419 +152 2 11.8856 16.2971 7.95074 9.26888 3.31932 -10.856 +153 2 12.3344 17.4798 8.78306 11.437 7.92329 -7.28752 +154 1 14.8861 15.2795 8.28974 -15.7554 0.3814 10.2226 +155 2 14.0374 15.7294 8.25106 -5.80199 2.88483 11.5438 +156 2 15.1981 15.4683 7.42207 26.2963 -2.4275 -26.3232 +157 1 17.5473 18.3112 0.374559 -18.2134 -6.45531 -4.6775 +158 2 18.2634 17.761 0.12213 22.8374 -25.4457 -15.3465 +159 2 17.9951 0.303427 0.894204 5.3706 29.2695 18.8411 +160 1 0.910079 10.3754 1.4141 -19.386 -45.7403 28.0244 +161 2 0.0926857 9.86966 1.69283 27.9138 11.9581 -5.7438 +162 2 0.554372 11.07 0.90565 -10.4877 37.4892 -28.5805 +163 1 1.56425 12.1843 3.32385 10.4497 17.8757 14.7846 +164 2 1.39557 11.5297 2.67534 -6.58566 -33.3087 -13.0061 +165 2 1.62643 12.9551 2.76927 3.66066 18.4363 0.784965 +166 1 0.55148 17.2559 4.87768 14.7947 16.704 -22.83 +167 2 -0.0171494 17.9122 5.24737 -12.9669 22.3753 -0.718336 +168 2 0.416337 16.5086 5.40997 -1.38762 -39.6682 22.4532 +169 1 1.10468 1.00284 9.3945 22.843 10.0615 -6.85845 +170 2 1.39907 0.698807 10.2625 -7.65597 -6.79115 6.92044 +171 2 0.213465 0.701839 9.27091 -15.6194 -8.53979 4.03703 +172 1 16.7947 2.33154 13.2859 2.87858 8.18604 -25.1476 +173 2 17.0129 2.55787 12.3417 -6.42954 -5.0835 25.2497 +174 2 16.4749 1.41822 13.3005 0.0523867 -3.46078 1.59731 +175 1 2.46566 15.827 12.1934 26.7468 -10.5365 13.2985 +176 2 2.93451 15.5288 13.0073 -9.90545 6.65681 -19.023 +177 2 2.95128 15.4495 11.4346 -3.9234 5.36807 1.6728 +178 1 16.4371 15.5461 5.94503 -4.66267 19.6238 -8.97399 +179 2 17.3612 15.5093 6.28134 -9.63254 6.93473 -7.38316 +180 2 16.3109 16.2991 5.29174 10.2179 -16.1602 20.4085 +181 1 5.84392 5.02209 11.7979 1.85982 -4.44524 -6.98506 +182 2 5.51366 5.87933 12.041 -2.35542 15.5447 8.97079 +183 2 5.10963 4.44446 12.0068 -1.26359 -10.5886 0.396425 +184 1 15.2223 4.8645 0.724291 -23.0156 -11.391 23.7803 +185 2 14.7624 4.52384 1.55825 21.1304 12.2284 -22.5635 +186 2 14.5125 5.05103 18.7394 0.751055 2.39009 4.23042 +187 1 16.343 16.2984 2.11648 10.3227 5.9227 -27.7144 +188 2 16.0112 16.8052 2.83865 -11.2354 10.0489 28.078 +189 2 16.6417 17.0002 1.51324 -1.84363 -9.29214 0.277829 +190 1 0.300695 4.8777 3.79796 -11.7144 38.8206 3.66766 +191 2 0.319109 5.88664 3.94702 6.24107 -45.2605 -6.61048 +192 2 1.15751 4.50056 4.01017 2.49534 2.82459 2.96224 +193 1 2.92353 14.9884 15.0405 10.7548 -7.33568 16.7257 +194 2 2.98085 14.609 15.9661 -8.47597 15.0336 -19.5599 +195 2 2.47925 15.8529 15.1074 -0.728265 -0.613609 8.13891 +196 1 1.11951 14.5697 9.5576 17.0302 46.4745 -20.2694 +197 2 2.08903 14.5584 9.38425 -20.4257 -12.3501 8.75388 +198 2 0.805573 13.7616 9.91809 5.52927 -28.6811 10.8766 +199 1 13.6617 16.6633 11.5459 -10.7506 10.3565 -21.4971 +200 2 13.3218 17.4276 11.0158 5.92664 -14.8533 17.3679 +201 2 13.3915 15.8986 11.0154 -3.11899 -0.859159 7.39997 +202 1 4.73366 1.47986 0.719369 -25.3145 -4.02421 3.51446 +203 2 4.15092 1.98399 0.125941 8.58395 1.79335 0.854136 +204 2 4.09918 0.853913 1.13528 12.7275 2.9151 -0.0185569 +205 1 1.42442 18.4742 11.9045 -6.93945 20.4545 -13.991 +206 2 1.2372 0.390371 12.6666 -0.822965 2.19478 3.53324 +207 2 1.89543 17.725 12.2367 7.95706 -17.4489 5.30436 +208 1 11.5469 10.1058 4.11116 26.1716 14.4711 -26.2735 +209 2 11.5284 10.5631 3.21886 -3.69376 -13.1884 23.9867 +210 2 12.5118 10.0773 4.36205 -26.1062 -0.534026 -7.20275 +211 1 8.37237 12.1712 3.75254 -13.3709 24.5961 46.1376 +212 2 9.17249 12.5936 4.11701 3.41223 -8.92861 -19.033 +213 2 7.75234 12.4533 4.48752 5.20668 -18.7884 -32.053 +214 1 14.3233 4.03204 3.29282 11.0049 6.10018 19.4579 +215 2 14.9517 4.19348 4.04461 -8.72763 -4.53117 -18.7735 +216 2 13.4979 4.46304 3.56838 3.12416 -1.49393 -3.31976 +217 1 5.58139 1.77074 7.50691 -36.613 -47.7339 30.604 +218 2 4.96189 1.1025 8.02564 35.7201 38.4984 -27.3817 +219 2 5.38779 1.57566 6.57729 1.13697 3.96791 -6.02851 +220 1 17.9042 1.1171 4.88471 6.84957 17.1887 -7.45832 +221 2 18.4571 1.56865 4.21188 -4.6905 -14.0516 5.22121 +222 2 17.737 1.81424 5.53024 -1.96776 -6.02251 3.4729 +223 1 6.82733 9.39684 4.48845 1.87187 -0.890058 -10.0607 +224 2 6.84716 9.53076 5.42818 -7.08772 5.76802 18.8049 +225 2 7.72364 9.08838 4.32443 4.93667 -1.85919 -9.57362 +226 1 2.70107 14.964 1.9632 9.79064 -8.50271 -23.1477 +227 2 3.33865 14.7342 2.63816 0.0868029 -0.794049 11.9475 +228 2 3.17782 14.7454 1.13419 -13.4 8.87294 12.5953 +229 1 17.2782 12.8964 13.1387 8.1593 -36.3772 6.82198 +230 2 16.3556 13.1177 13.3173 4.03584 18.7537 -2.31465 +231 2 17.8303 13.6552 12.9439 -8.38561 20.0322 -1.78655 +232 1 15.018 10.5797 1.38541 -30.6488 -33.8734 -22.7761 +233 2 15.5405 11.2097 1.82354 25.6355 33.1541 21.1587 +234 2 14.2986 11.0703 0.97193 1.92599 -0.723232 4.24038 +235 1 5.71261 6.94641 4.5266 2.6516 -23.4686 10.5302 +236 2 5.87991 7.88124 4.41392 4.1014 10.4162 -0.896017 +237 2 6.40034 6.62744 5.14459 -6.91809 0.316355 -6.72793 +238 1 8.10894 8.26231 10.1757 -1.61977 4.99166 17.0229 +239 2 8.63366 8.87039 9.65704 12.8257 12.1371 2.09156 +240 2 7.5873 7.82886 9.51802 -16.026 -14.2044 -11.4362 +241 1 13.5265 18.2929 5.80397 -22.7677 -1.43199 15.791 +242 2 12.744 0.210577 5.63003 6.52185 -0.137688 -2.34328 +243 2 13.224 17.7307 6.55929 8.82644 11.7072 -16.2211 +244 1 0.31998 2.55606 0.111337 -23.7151 48.4906 1.53453 +245 2 18.006 2.70756 18.6319 7.21623 -15.3908 0.76394 +246 2 0.639493 3.49242 0.214062 7.71863 -30.3236 1.31164 +247 1 12.6438 10.9651 9.76843 -27.6007 42.776 -15.0826 +248 2 11.6462 10.8587 9.68427 36.5826 -6.8361 3.61513 +249 2 13.0097 10.1328 10.024 -0.792921 -29.0746 6.76076 +250 1 0.78357 12.2825 11.0843 20.7577 -6.91251 -2.74458 +251 2 18.4749 12.2741 11.1385 -12.0685 2.84404 7.0736 +252 2 1.15918 12.6384 11.9096 -11.1326 -3.84191 -3.75479 +253 1 5.04379 7.22322 13.4829 1.39832 5.89977 -6.97466 +254 2 5.58123 7.93479 13.1271 0.448534 7.96016 -10.0051 +255 2 5.53384 7.00565 14.2746 1.03136 -7.66768 11.7435 +256 1 1.27874 6.97532 11.834 -32.074 -43.2189 -14.0481 +257 2 0.482678 7.18669 11.3131 10.1443 0.561183 6.98996 +258 2 1.70367 7.78255 12.0103 18.1825 36.8435 9.31001 +259 1 15.4541 9.47267 12.3132 5.88964 23.7827 6.22024 +260 2 15.5166 10.4677 12.3686 -5.40153 -30.7713 4.20372 +261 2 15.4815 9.07432 13.2056 -1.6395 12.2138 -11.1334 +262 1 16.6425 12.9485 5.45228 -24.7761 13.2233 -32.5849 +263 2 16.3124 13.8685 5.42836 11.1894 -7.98651 20.9726 +264 2 16.4187 12.7313 4.52305 11.1313 -16.3356 15.5726 +265 1 6.1733 10.0557 0.193027 -12.4899 -11.5053 -32.3049 +266 2 5.38495 10.4604 0.58061 6.43577 -0.470902 4.897 +267 2 6.88008 10.1049 0.827544 12.5305 3.42311 14.2724 +268 1 12.3659 6.05415 4.04188 -22.1763 -21.8278 15.5685 +269 2 12.3683 6.79715 3.46108 4.13216 24.0909 -16.7914 +270 2 11.421 5.79287 4.05326 15.4186 -0.211849 3.77561 +271 1 0.132582 12.8231 0.203992 -0.195483 1.63508 -4.90635 +272 2 -0.0245094 13.5503 0.825031 2.49545 -1.98409 0.771993 +273 2 18.2458 13.055 18.0666 5.13636 -1.5464 3.82803 +274 1 3.83888 18.5816 8.61379 -9.81831 -4.88162 -16.6552 +275 2 3.52001 18.2631 7.75085 8.43173 -4.7192 1.01067 +276 2 3.03206 0.305129 8.96677 -7.80256 7.43459 9.99927 +277 1 7.39556 17.2738 4.45596 16.9172 12.0122 12.5371 +278 2 7.99849 17.9848 4.79149 -15.6229 -16.9846 -19.2965 +279 2 7.33818 17.3251 3.48629 6.36463 5.57381 8.87833 +280 1 9.21998 17.0388 12.2284 15.8258 3.83046 11.207 +281 2 9.35195 16.1931 11.7423 2.16771 12.8413 7.7779 +282 2 10.0104 17.2216 12.8137 -16.5375 -11.854 -19.0408 +283 1 13.3184 13.0063 7.94019 -19.3301 -32.807 5.85066 +284 2 13.1883 12.2647 8.56801 -4.60418 3.91603 -7.64254 +285 2 14.1459 13.3708 8.19821 21.3317 21.1541 5.11013 +286 1 14.9844 2.95035 15.3504 8.07249 -1.73557 -24.8008 +287 2 14.3 2.40675 14.9389 -0.805511 -1.63288 7.60525 +288 2 15.6705 2.98762 14.6436 -9.05507 2.69068 16.8604 +289 1 9.85476 15.5033 17.004 5.70996 8.22456 -10.0233 +290 2 10.2769 14.6753 16.7296 0.407564 1.12786 2.5917 +291 2 9.2992 15.3275 17.7693 -4.49302 -4.18434 5.79618 +292 1 11.2887 8.25054 16.5462 4.3815 15.8935 1.4126 +293 2 10.7498 7.72178 15.9677 -11.4268 -3.01506 -11.0903 +294 2 11.7109 7.60541 17.1026 7.03572 -6.39426 11.2088 +295 1 3.78312 18.1923 16.7229 -8.20319 16.8802 -14.09 +296 2 4.23544 17.5706 17.2928 8.99584 -2.65396 14.876 +297 2 3.78517 0.451969 17.0887 5.65759 -16.2586 2.71634 +298 1 2.1977 4.10819 8.95021 24.5715 -13.8141 31.6135 +299 2 3.03624 3.61916 8.82088 -15.7399 12.2693 -11.2697 +300 2 2.14197 4.07166 9.94067 -11.3718 7.67499 -23.2123 +301 1 9.90974 10.3516 9.73776 -22.8793 37.5197 3.40937 +302 2 9.44348 11.1923 9.4561 16.1923 -27.4723 -0.755713 +303 2 9.93951 10.4177 10.7077 4.76489 -7.47333 -8.73237 +304 1 9.73601 0.810068 10.8572 -6.50885 -0.835519 -1.39877 +305 2 9.40585 18.6129 11.1735 2.22486 -11.7661 13.7712 +306 2 9.0915 1.01857 10.1847 -1.93261 14.5334 -11.6688 +307 1 9.19364 15.2092 10.2107 -23.0073 -10.2994 -8.74256 +308 2 8.9841 16.0542 9.76587 1.98806 -14.8547 5.4661 +309 2 8.35152 14.6762 10.1166 22.3916 12.2872 5.93767 +310 1 0.995532 9.29186 10.3281 47.9462 -2.63812 -8.64675 +311 2 1.22741 10.2031 10.5086 -13.3799 15.5027 2.96196 +312 2 1.9063 8.9262 10.1621 -35.7029 0.949407 3.82346 +313 1 16.813 4.88766 8.1932 11.5161 -10.5322 32.9144 +314 2 16.1615 5.34773 8.77307 11.8935 -6.11126 -18.0819 +315 2 17.4051 4.37395 8.80041 -19.6267 13.8505 -17.9411 +316 1 14.6429 14.6942 0.394535 -7.00543 -1.89626 8.24203 +317 2 15.0463 15.2494 1.09531 -2.64327 -9.316 -7.76003 +318 2 13.8679 14.2346 0.794348 15.878 11.3494 -8.58286 +319 1 3.51953 11.0524 9.63262 1.11689 7.20138 -8.56155 +320 2 3.49309 11.4422 10.5196 2.01858 0.130954 -3.30783 +321 2 3.17116 11.7397 9.0203 2.67149 -7.88535 6.47818 +322 1 11.039 10.8616 1.27104 8.39953 16.0658 -8.46941 +323 2 11.1885 11.6907 0.750788 0.782166 -19.893 14.3131 +324 2 10.1072 10.6419 1.14889 -0.773464 -1.49716 1.06219 +325 1 13.2204 7.07184 12.8933 -24.0174 5.01566 -6.09093 +326 2 14.1394 6.83939 12.9167 20.0602 -3.76028 0.39046 +327 2 12.7464 6.22555 12.8749 2.49778 2.97258 -0.29329 +328 1 9.62856 1.88969 0.946546 9.2636 -0.931103 20.1878 +329 2 8.76541 2.02695 0.593353 -22.3319 -0.80038 -4.92587 +330 2 10.1675 1.74594 0.181071 13.2226 0.132969 -11.6901 +331 1 10.5934 13.5316 4.73807 16.1446 0.574492 13.3086 +332 2 11.4317 13.0614 4.94174 -10.7106 3.3069 -14.0299 +333 2 10.5321 14.1207 5.51129 -4.24994 -4.20037 -10.3127 +334 1 14.2715 1.70318 10.8964 -1.77809 5.91235 7.28652 +335 2 15.0728 1.25501 10.5853 5.24738 9.35157 -1.74174 +336 2 14.4034 2.67095 10.8772 7.32957 -6.49183 -2.39775 +337 1 14.6603 12.4192 11.7243 1.91159 -25.2344 -56.6412 +338 2 15.4845 12.4874 11.1931 -4.23005 7.1619 22.5795 +339 2 14.0903 12.0081 11.0211 -1.48986 11.1607 31.5891 +340 1 8.24886 5.08654 9.79134 -29.2123 3.64284 23.7692 +341 2 7.42109 5.02927 10.3149 15.0309 17.1198 -4.03621 +342 2 8.23121 4.21184 9.43797 12.1669 -22.8524 -17.3047 +343 1 1.59528 16.8201 18.3251 -4.66834 32.7155 -7.23976 +344 2 1.93304 17.2062 17.488 -5.12416 -8.69561 13.5025 +345 2 1.82608 15.9028 18.3034 8.21551 -19.1337 -3.40609 +346 1 1.44054 17.2474 15.3375 38.2305 -7.16391 -6.50211 +347 2 1.35107 18.1379 15.6308 4.79859 24.8425 9.12518 +348 2 0.562777 16.9452 15.3387 -39.5261 -18.284 -3.02502 +349 1 3.72855 5.57524 6.20331 -9.94128 10.6794 2.05156 +350 2 3.21297 6.20603 6.76334 9.83918 -6.42931 -13.7589 +351 2 4.29894 6.06824 5.5848 -3.89827 7.08279 4.15512 +352 1 12.3545 9.42683 14.1827 20.4014 -41.9092 8.4814 +353 2 12.8623 8.59837 13.88 -21.4785 35.8512 3.66034 +354 2 12.0611 9.1345 15.077 2.36507 11.6403 -12.9904 +355 1 4.03327 15.2744 6.905 24.5442 3.45717 -5.69457 +356 2 3.46314 16.0225 6.67296 5.01039 2.15408 -3.12402 +357 2 4.97164 15.5268 6.67147 -27.9532 -4.4537 7.17357 +358 1 0.606997 8.56433 14.8637 1.00605 -0.185347 4.59471 +359 2 0.51054 9.52697 15.0006 4.18475 -5.95105 -3.81642 +360 2 1.25745 8.45601 14.1476 -5.10421 5.72757 5.73964 +361 1 12.9756 8.36618 10.3398 20.3701 -17.1189 -10.5242 +362 2 13.727 7.8435 10.0036 -6.14808 8.99881 -11.6124 +363 2 12.9675 8.02293 11.2263 -11.3517 2.56625 21.5008 +364 1 15.2884 7.63693 3.49378 10.1588 18.7913 -12.1111 +365 2 14.5458 7.1482 3.08376 7.93209 -0.245397 21.6039 +366 2 15.5211 7.50792 4.43838 -15.1505 -14.5868 -6.72816 +367 1 17.3202 6.64717 0.0328861 -29.9623 13.6257 -2.83905 +368 2 16.7745 5.97673 0.482414 9.93705 -0.647346 -3.81794 +369 2 16.6178 7.22121 18.2734 18.8696 -9.84661 9.86066 +370 1 8.80495 6.92785 7.84504 -31.0915 -18.6038 9.28479 +371 2 9.6769 7.2872 7.80779 30.3288 7.87046 2.96903 +372 2 8.72406 6.35246 8.64105 6.6093 9.83872 -10.9319 +373 1 12.3211 0.614363 1.17365 13.0662 -3.77868 -0.487657 +374 2 13.0766 0.983141 1.64654 -0.239842 1.32967 3.5541 +375 2 12.751 18.5673 0.657414 -10.2946 0.778432 -2.83622 +376 1 5.67951 15.1028 14.5131 10.9467 16.6442 -3.65569 +377 2 4.71936 15.1727 14.6088 -3.18386 3.297 0.861488 +378 2 6.03308 15.9436 14.1233 -11.409 -15.106 9.73801 +379 1 3.83531 6.52602 1.68735 -5.34791 11.2881 1.09554 +380 2 3.46655 7.33088 1.27913 5.03876 -12.3281 -3.02901 +381 2 3.83759 6.80671 2.60341 5.67562 -6.55284 8.9174 +382 1 3.89065 11.6139 12.2421 9.17745 -10.34 -2.42323 +383 2 4.7546 12.041 12.3761 -4.43478 1.7756 4.32079 +384 2 3.22616 12.1252 12.7041 -4.55935 10.4369 8.15325 +385 1 5.44913 3.8771 15.872 6.89679 52.3696 13.3559 +386 2 6.00532 3.19945 15.5174 15.3476 -19.3003 -7.67953 +387 2 6.04432 4.69577 15.9682 -27.8341 -34.2187 -5.04159 +388 1 14.46 10.319 4.39654 9.99722 -28.3378 -34.0856 +389 2 14.8446 9.82936 5.13517 -3.65574 0.244774 4.37558 +390 2 14.7053 9.78242 3.56924 -11.9433 24.8074 33.8136 +391 1 7.944 17.2975 9.23787 -28.0002 30.4191 -3.50914 +392 2 7.19679 17.6006 9.79194 10.1387 -11.5361 -1.79961 +393 2 7.93806 17.9436 8.50883 9.12371 -8.84918 -0.989999 +394 1 4.50274 14.4265 3.96251 25.8442 16.5744 44.5421 +395 2 4.82189 15.3364 4.24204 -15.9069 -22.6382 -13.9696 +396 2 4.78076 13.8411 4.72747 -13.1976 12.376 -28.3375 +397 1 14.3227 7.38582 15.7589 14.6846 6.74467 9.8564 +398 2 15.2487 7.24382 15.4614 -20.8339 3.06086 7.28672 +399 2 14.432 7.78597 16.648 -5.3607 -7.66211 -14.83 +400 1 2.87305 18.2228 1.9038 16.9424 31.4889 37.3817 +401 2 2.5254 17.6641 1.24513 -20.0746 -27.9737 -30.7942 +402 2 2.12041 18.5329 2.44243 8.04928 -1.15784 -8.26421 +403 1 7.96513 1.6038 4.534 28.375 12.0389 1.8382 +404 2 7.4881 1.94169 3.78174 -16.4915 0.831655 -6.1583 +405 2 8.81315 2.08427 4.47067 -11.0504 -12.9149 7.37414 +406 1 2.66628 14.1304 17.7551 -36.5802 -20.3813 5.76686 +407 2 1.82799 13.6385 18.0009 26.1666 13.51 -7.41699 +408 2 3.38829 13.5766 18.1016 -3.21353 7.84202 -3.40779 +409 1 0.72398 1.68558 13.861 19.6061 1.62564 -3.20216 +410 2 0.832024 1.51571 14.7895 8.81281 -5.19825 13.648 +411 2 18.448 1.87896 13.7961 -22.7247 6.41229 -8.76432 +412 1 4.5528 18.6039 13.9643 16.282 -5.93943 -10.6264 +413 2 5.43228 18.1791 13.8337 -18.6035 11.3559 2.42201 +414 2 4.30609 18.3878 14.8696 -5.35687 -0.29015 4.72759 +415 1 7.10471 0.475722 18.3652 -9.95344 30.3778 33.8159 +416 2 7.09526 0.10374 17.5021 -2.11792 -9.18089 -28.9852 +417 2 6.24907 0.928295 18.5508 11.5399 -12.8337 -6.73806 +418 1 16.1003 18.4419 14.1295 -36.1288 -26.1963 -8.72431 +419 2 15.3858 17.8107 13.8537 25.0074 20.4613 -2.43664 +420 2 15.9155 18.5409 15.0697 10.6475 8.10349 1.05551 +421 1 10.1087 4.51964 16.2872 -49.6317 2.46368 -20.184 +422 2 10.9899 4.47274 16.5903 35.3659 -6.27505 9.52333 +423 2 9.84839 3.65208 15.9265 12.032 5.89647 9.33422 +424 1 15.84 17.9245 4.41355 -16.3771 8.07859 19.8211 +425 2 16.4973 18.6399 4.5293 -6.75294 -6.64677 -2.2152 +426 2 15.0245 18.216 4.92863 29.2279 -12.5546 -21.8691 +427 1 6.93052 17.3604 13.733 43.7573 11.6301 8.94285 +428 2 7.46287 17.7112 14.5144 -20.3873 -12.0805 -21.5216 +429 2 7.61723 17.2481 13.0216 -16.2109 2.19972 16.1164 +430 1 13.284 6.56612 6.73549 -17.3988 -10.9235 -13.9284 +431 2 14.2147 6.66272 6.66556 31.8926 9.42178 10.838 +432 2 13.0817 6.39483 5.81333 -16.4457 -2.73061 -4.18006 +433 1 7.68008 2.38704 9.18412 -10.173 -8.0052 -21.8631 +434 2 7.24249 2.31281 10.0234 -2.88588 -0.126179 20.3224 +435 2 6.98126 2.1061 8.54708 21.029 6.80491 7.05088 +436 1 15.1532 14.8723 13.6487 -17.4978 4.30428 5.82091 +437 2 15.0143 15.0659 14.5909 6.59258 -1.67926 -7.31154 +438 2 14.3234 15.1254 13.2077 14.4343 -4.04757 1.78875 +439 1 9.30028 8.33456 3.70705 10.2977 -8.98362 5.75949 +440 2 10.1463 8.82212 3.80538 -6.03443 -8.47657 3.00821 +441 2 9.47356 7.38745 3.89392 -0.00834887 14.0135 -2.32863 +442 1 17.6906 13.477 16.4461 19.9282 13.2905 -5.82842 +443 2 16.7369 13.3711 16.3792 -1.87427 5.41308 -4.03884 +444 2 17.9311 14.3351 16.016 -12.453 -14.9372 6.18952 +445 1 5.04349 10.6567 2.59903 16.1191 -13.6813 18.2195 +446 2 5.79495 10.2927 3.12129 -13.5181 3.52014 -12.0414 +447 2 4.57705 11.1773 3.24438 -8.0447 10.2459 5.04269 +448 1 3.70971 8.35842 10.3252 1.44092 -18.6834 3.58878 +449 2 3.85247 9.29033 10.1825 3.16815 17.7869 -8.4001 +450 2 3.85129 8.23256 11.2753 -2.11366 -0.888936 -6.9574 +451 1 16.1019 7.11228 6.32302 5.1556 -18.0856 -12.5793 +452 2 16.7603 7.67894 6.76117 -3.13697 -10.0137 -6.06994 +453 2 16.5199 6.22503 6.17941 -9.70023 19.4355 5.8489 +454 1 15.1873 7.00993 9.1119 -0.598311 32.9952 -33.7165 +455 2 16.0219 7.38603 9.44635 -11.3494 -6.74009 0.758637 +456 2 15.0255 7.54922 8.27157 3.37955 -23.1281 33.9738 +457 1 6.44391 13.1496 12.9059 -4.52757 0.45998 7.29234 +458 2 7.24313 12.6736 13.1625 -0.99472 -4.48021 -2.73775 +459 2 6.29798 13.7908 13.6311 -2.25413 -7.45453 -16.6836 +460 1 12.1229 4.49714 13.069 31.9377 20.6864 19.2416 +461 2 12.2438 4.59516 14.0263 7.18846 6.47209 -3.71556 +462 2 11.355 3.98337 13.0276 -40.2556 -25.9573 -14.351 +463 1 11.341 8.18871 7.85243 -8.78275 4.89867 3.16356 +464 2 12.019 7.65272 7.40248 3.56578 3.50389 11.6767 +465 2 11.6495 8.4222 8.75253 4.0122 -9.00416 -11.7002 +466 1 17.1801 10.777 7.4192 7.36201 -8.80257 6.42916 +467 2 17.8272 10.0453 7.20283 -14.4353 25.3005 -3.23105 +468 2 17.1099 11.4706 6.73084 6.53972 -12.3853 -1.04707 +469 1 5.23123 18.1422 11.0533 -19.2518 -11.1169 -0.556795 +470 2 4.68428 18.0818 11.8689 9.03658 -0.237539 -15.4649 +471 2 4.66385 17.8138 10.3113 13.0077 11.3369 14.9543 +472 1 7.56693 17.6215 1.82415 1.62007 -3.46367 5.28784 +473 2 7.78898 16.8334 1.34681 6.63524 -26.0188 -1.32905 +474 2 7.45125 18.2129 1.09256 -3.64481 20.3372 -5.96154 +475 1 1.86389 12.9287 13.6093 11.2123 10.389 11.461 +476 2 1.60858 12.3493 14.3514 0.368407 5.87334 -8.62616 +477 2 2.19533 13.7617 14.0254 -8.04715 -19.4049 -4.74077 +478 1 9.73211 6.79545 14.8053 -13.3635 29.1677 -1.2594 +479 2 9.95388 5.9401 15.1198 6.74212 -35.5267 16.6171 +480 2 9.99758 6.80472 13.8879 2.87601 5.55808 -10.3757 +481 1 15.2079 4.3816 10.7747 2.87683 -10.6846 -6.34453 +482 2 16.1141 4.09829 10.8354 14.0041 -14.4682 -8.99775 +483 2 15.2413 5.10857 11.3759 -13.982 19.572 13.657 +484 1 11.1943 6.12299 0.161942 7.30858 3.38886 3.78771 +485 2 11.3169 5.17116 0.363074 -11.79 12.5462 -9.55941 +486 2 10.2709 6.35961 18.5708 8.1781 -12.6509 6.67443 +487 1 0.185288 11.3311 15.1365 -30.887 25.32 -22.6423 +488 2 18.3259 11.8316 14.411 15.9364 -20.9841 19.9458 +489 2 18.5436 11.8171 15.9275 6.31494 -1.3813 -2.75882 +490 1 7.07253 9.14554 7.26503 -12.8693 -9.44748 7.54332 +491 2 6.53496 8.39024 7.60511 8.01051 18.2562 -7.56901 +492 2 7.96025 8.78683 7.22728 5.66006 -0.214789 -0.295522 +493 1 18.4466 15.4455 12.3524 0.715601 -5.5542 4.25712 +494 2 0.765537 15.5739 12.2932 -9.35503 -1.07101 -3.81958 +495 2 18.1041 15.6865 11.4834 1.82716 1.84183 -0.0676895 +496 1 16.5728 4.36435 5.2485 -25.4993 -8.29978 29.4912 +497 2 16.6816 3.92322 6.14286 5.98391 16.1522 -30.7717 +498 2 17.375 4.39451 4.72672 17.8313 -3.46111 1.89189 +499 1 17.7791 3.0704 10.7152 16.7916 7.15275 7.98838 +500 2 0.0816242 3.14072 10.966 -13.8603 5.05813 -1.71981 +501 2 17.7027 2.20602 10.3066 -7.17166 -8.4112 -5.21368 +502 1 12.3075 0.0618611 10.1685 -8.15907 17.9474 -0.312818 +503 2 11.3684 0.344551 10.3468 27.9971 -1.27027 -0.956139 +504 2 12.8942 0.865557 10.2681 -22.4015 -23.39 -3.54403 +505 1 10.3613 9.82386 12.3172 12.1455 12.129 19.7304 +506 2 11.1427 9.8808 12.9129 -10.2174 -2.53791 -7.09814 +507 2 10.1997 8.88396 12.252 -0.966331 -12.4705 -0.927319 +508 1 0.481536 2.83002 7.02126 3.70324 23.8076 -10.0458 +509 2 0.770856 3.62826 7.51109 -3.83076 -19.2444 -0.666321 +510 2 0.694466 2.06428 7.55035 5.7415 -3.83046 10.8422 +511 1 0.467049 15.2425 6.91705 -4.45928 -38.0226 -11.2702 +512 2 0.600151 15.6263 7.78281 2.30728 -6.41275 13.0317 +513 2 0.61271 14.2361 7.00049 -2.84554 47.7716 -5.16909 +514 1 16.9541 7.01237 15.3291 23.6374 -7.48971 -3.1828 +515 2 17.7457 7.53254 15.1705 -1.99719 18.034 -6.10418 +516 2 17.38 6.19105 15.5941 -13.3003 -10.4743 0.120416 +517 1 9.01017 12.4224 8.1441 -46.2717 9.6088 -11.1501 +518 2 9.26268 11.8248 7.45061 25.2615 -14.9445 -10.6927 +519 2 8.05034 12.5239 7.91838 26.5695 6.53823 20.3475 +520 1 1.26455 1.94093 3.05316 3.58571 9.71968 -12.011 +521 2 1.22461 2.59742 2.34045 -8.12686 -11.986 1.71554 +522 2 1.93366 2.31359 3.63129 0.35358 -2.72116 4.87465 +523 1 4.13309 15.1146 9.63821 -4.623 1.46382 -0.938733 +524 2 4.12694 15.148 8.67475 -7.89004 5.45838 -0.100118 +525 2 4.98588 14.7259 9.81048 11.3537 -4.87926 10.963 +526 1 7.17766 2.17952 14.5652 7.62536 9.73749 11.0593 +527 2 6.96972 1.69872 13.7643 -0.327528 -0.451328 -7.35604 +528 2 7.66158 2.98182 14.3072 -3.86315 -8.18785 -0.50787 +529 1 18.6094 14.7115 2.1553 18.1066 -29.4746 -3.14947 +530 2 0.852094 15.108 2.23259 -6.38197 3.09186 -0.259441 +531 2 17.9366 15.3527 2.32074 -15.2526 23.2774 3.26778 +532 1 9.94663 2.7868 12.9455 2.69617 -13.1789 -11.1834 +533 2 9.77369 2.19316 12.1903 7.43131 1.21406 6.14773 +534 2 9.20096 3.38667 12.9408 -6.30409 9.38042 4.37845 +535 1 2.80852 8.91644 13.0153 -16.8956 -9.28674 -0.0207487 +536 2 3.13809 9.78934 12.8448 9.36486 20.7895 -4.33486 +537 2 3.52774 8.43066 13.407 13.2058 -10.3846 6.75792 +538 1 3.23128 8.35577 3.63883 6.10249 8.71431 60.2633 +539 2 3.54401 9.08838 3.13137 7.96401 15.5303 -21.3649 +540 2 3.46232 8.64756 4.58519 -13.4978 -19.9669 -35.5279 +541 1 5.63324 7.19832 8.5125 -13.133 -10.0414 6.96154 +542 2 5.51092 6.25688 8.34615 12.8941 -5.44374 -4.51219 +543 2 4.92213 7.36133 9.14092 2.83191 13.4678 4.26874 +544 1 14.878 1.27944 2.0109 -7.35803 -30.2596 -13.1701 +545 2 14.8616 1.98275 2.64555 4.54601 24.3613 2.83628 +546 2 15.264 1.50064 1.14913 0.22226 12.7122 6.62367 +547 1 8.2353 15.1956 0.84899 9.2054 13.6294 -15.3468 +548 2 9.04355 15.0937 1.38227 -7.5254 -5.87742 4.76726 +549 2 7.50355 14.6763 1.20804 4.58246 -4.32042 7.88142 +550 1 15.6328 1.34461 7.23795 -19.9173 -11.1245 -9.46976 +551 2 14.9591 0.718796 6.85982 16.5955 19.1651 8.9454 +552 2 15.1508 2.16575 7.45752 1.02199 -7.71962 -3.30529 +553 1 4.91374 13.0908 18.526 15.2565 -4.60213 14.3208 +554 2 5.33439 13.1154 0.77269 -6.07604 1.59812 -16.6926 +555 2 5.51105 13.5936 17.9543 2.83588 -2.74206 0.160853 +556 1 15.3493 8.4742 18.1502 12.1518 9.73195 -18.1744 +557 2 15.7592 9.1135 17.5088 -10.0207 -13.011 16.7995 +558 2 15.2243 8.95162 0.336167 -0.033387 6.18709 -0.40176 +559 1 12.0721 3.03363 18.372 7.89134 -10.3745 2.1206 +560 2 12.0185 2.56449 0.551271 -8.88822 8.03447 17.3967 +561 2 12.5632 2.36483 17.898 4.02516 4.57474 -24.0136 +562 1 13.2076 12.6757 5.17908 4.47921 -5.37266 1.03993 +563 2 13.7293 11.9632 4.79272 -2.12471 -1.88137 -7.76598 +564 2 13.3867 12.5644 6.11349 -3.52883 8.17381 9.78336 +565 1 6.04737 7.04753 0.0353989 10.049 -23.447 -5.31085 +566 2 6.01346 7.99319 18.6275 -7.37118 27.2698 7.20756 +567 2 5.32085 6.74358 0.593628 -6.10646 3.40609 1.47388 +568 1 17.7373 16.0235 15.0083 12.9173 -11.5355 46.7271 +569 2 16.9426 16.5159 15.2406 -3.68569 -0.0523083 -17.9381 +570 2 17.9142 15.8937 14.0864 -12.7219 4.58342 -31.2732 +571 1 13.1912 1.0014 16.5506 10.6966 -14.1722 10.2872 +572 2 14.1553 0.911674 16.6931 -11.9901 3.10273 -3.01829 +573 2 12.8874 0.074803 16.5753 -2.30324 8.04411 -4.14072 +574 1 11.1133 14.5665 7.20897 13.0955 23.3619 -16.6223 +575 2 10.3963 14.2935 7.74934 -21.4591 -15.3449 18.7975 +576 2 11.8402 13.9563 7.34501 4.8973 -5.05394 6.63835 +577 1 17.5096 8.63113 2.08657 0.966478 12.3426 12.6691 +578 2 16.6632 8.50317 2.50987 -10.5053 2.55961 10.3047 +579 2 17.5113 7.91267 1.47949 7.23292 -21.4893 -25.4513 +580 1 12.353 7.99884 2.01581 -2.70101 10.6364 -12.6504 +581 2 12.1945 8.88312 1.63494 1.68617 -6.44935 12.5501 +582 2 11.9639 7.41552 1.35659 -1.58766 -9.18843 -2.08326 +583 1 11.8879 14.6194 10.3406 -20.0746 -33.6598 -22.8547 +584 2 12.0361 13.784 9.8263 4.17148 28.2224 18.5196 +585 2 10.9018 14.6878 10.3309 21.6541 8.7111 3.83339 +586 1 6.88836 7.04362 15.6058 16.1194 20.5136 16.4981 +587 2 7.8035 7.27617 15.3369 -14.4637 -10.2261 -3.41305 +588 2 6.75267 7.59066 16.4113 -4.12685 -13.7627 -18.0291 +589 1 8.00073 4.72844 13.473 32.6072 13.4681 12.0072 +590 2 7.24466 4.78195 12.9199 -26.1194 -0.34176 -19.7698 +591 2 8.43099 5.60279 13.3668 -6.56701 -17.694 4.3215 +592 1 13.409 12.181 14.2619 -2.29334 -12.519 -3.59046 +593 2 13.0674 11.2691 14.1939 2.47622 3.528 5.79283 +594 2 13.8091 12.3245 13.3914 2.14013 7.29019 1.49174 +595 1 14.8335 9.42126 7.30208 -1.23415 -9.7028 -7.755 +596 2 15.6553 9.87909 7.43544 15.0677 5.06613 0.278043 +597 2 14.1895 10.0298 7.62302 -19.0881 6.3544 7.09879 +598 1 12.6523 17.0615 3.07749 -9.63712 20.8437 4.73829 +599 2 12.9489 17.4748 3.92954 -9.59054 -7.90452 -22.4084 +600 2 12.0211 17.6908 2.6147 24.5964 -20.1603 22.3384 +601 1 1.16316 7.14216 17.4575 -7.53687 9.98877 -12.7143 +602 2 0.304551 7.18474 17.9202 3.89796 -5.88799 -6.19513 +603 2 1.03245 7.53978 16.5617 1.30151 -5.77621 16.2427 +604 1 12.7701 5.15004 15.6505 19.6392 -10.8067 9.95473 +605 2 13.4563 4.50157 15.9538 -13.2351 19.2956 -11.0391 +606 2 13.2014 6.03319 15.6187 -0.0564141 -13.897 1.41482 +607 1 2.5292 3.39223 4.98971 -11.294 24.8894 43.5462 +608 2 1.79321 3.13497 5.63732 25.431 9.26734 -19.6171 +609 2 2.95221 4.24201 5.36402 -18.0427 -37.3772 -14.0443 +610 1 8.3195 11.2975 13.4498 34.4282 -42.0873 60.0692 +611 2 8.53145 10.9623 14.3727 -32.5783 27.093 -24.5589 +612 2 9.06913 10.8398 13.0623 -1.46455 6.72769 -32.5395 +613 1 12.8789 1.33599 13.3369 -0.326833 21.0111 -2.4484 +614 2 13.4114 1.42549 12.5087 -12.3149 4.19021 14.3531 +615 2 12.3728 2.16885 13.5095 17.1543 -18.8215 -15.124 +616 1 6.3438 13.6989 2.14861 -9.76603 2.4566 0.239062 +617 2 5.66699 13.9965 2.80165 17.5467 -9.19207 -8.6938 +618 2 6.94024 13.0708 2.57673 -0.273551 -0.649347 7.27334 +619 1 15.9211 6.60722 12.7931 -16.6599 -18.553 -4.38331 +620 2 16.3967 7.19214 12.2261 12.0088 12.5524 -15.4249 +621 2 16.3823 6.6241 13.6257 5.92705 1.19016 14.7721 +622 1 16.8355 0.712467 9.59592 -3.36362 -23.3789 -3.56206 +623 2 16.7779 18.376 9.75078 1.74957 20.9638 -0.413143 +624 2 16.4581 0.840534 8.70411 1.17104 2.38037 5.50581 +625 1 6.14488 11.7511 8.38011 -0.18946 -41.167 -3.37934 +626 2 5.27459 11.5011 8.78729 18.3987 2.85732 -10.3128 +627 2 6.60987 10.8879 8.11154 -22.1828 30.5528 10.1053 +628 1 2.89693 8.62105 0.44295 -56.4203 1.00956 -31.5069 +629 2 2.27197 8.22062 18.4324 34.822 -7.67477 5.45833 +630 2 2.23776 9.23156 0.789096 17.398 15.3469 20.296 +631 1 10.1637 10.4615 6.50349 -4.04384 3.34709 -8.13679 +632 2 10.5967 9.72069 6.94847 1.64295 -0.870339 0.249421 +633 2 10.4974 10.4621 5.5852 -1.057 -0.999308 12.8758 +634 1 6.73224 15.6973 6.55436 -2.09809 -5.48823 4.73835 +635 2 7.11043 16.1412 7.33204 2.41282 1.16671 -8.98558 +636 2 7.01002 16.1566 5.74315 2.18916 7.51026 7.17736 +637 1 6.44608 13.1679 5.58195 -4.20705 -14.9444 9.79279 +638 2 6.65412 13.9682 6.06813 3.08652 7.67851 0.170606 +639 2 6.07667 12.5708 6.24938 0.761343 1.39557 -4.00611 +640 1 16.8208 12.5604 9.84104 -2.42329 -13.6856 -22.0974 +641 2 16.9708 11.9197 9.11347 0.32984 0.887075 14.5477 +642 2 16.637 13.3652 9.35916 0.987515 11.3295 4.43609 +643 1 6.04174 2.95051 2.84722 -0.719082 -29.0389 17.5165 +644 2 6.39757 3.79665 2.63265 6.28437 26.7212 -14.5644 +645 2 5.5959 2.56013 2.08759 -0.264068 2.45464 -11.4985 +646 1 10.912 3.32579 3.30021 -11.54 -3.72468 -0.286686 +647 2 10.265 3.99241 3.57025 6.99069 0.708994 3.18227 +648 2 10.4899 2.90229 2.54711 3.22659 -3.75767 -5.68185 +ITEM: TIMESTEP +20 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.70913 7.06604 17.9499 1.08039 -7.3052 -10.6944 +2 2 7.76309 6.93671 18.0927 2.86377 -0.0634365 6.14939 +3 2 8.89082 6.62218 17.113 -0.435012 1.17195 3.96762 +4 1 18.5701 8.27154 6.84569 7.63886 -4.25596 16.0618 +5 2 0.0770478 8.01704 5.94511 2.80666 -2.10014 -27.175 +6 2 0.448594 7.6266 7.34851 -2.05713 5.96795 6.45131 +7 1 8.39922 18.5714 6.82203 6.72948 10.2859 -1.45868 +8 2 9.32775 0.155905 6.65662 -6.00666 -1.87083 0.283604 +9 2 7.88802 0.6421 6.41318 2.19693 -3.22314 0.641978 +10 1 6.59462 1.83749 11.6886 4.57701 1.91935 4.50468 +11 2 5.92153 2.26167 12.2253 -5.29818 6.79114 -2.36061 +12 2 6.2022 0.990271 11.4833 -4.39091 -13.1588 -5.35683 +13 1 7.12455 5.7334 2.35273 -30.6289 32.8622 11.4294 +14 2 6.61502 6.28908 3.00258 14.1285 -25.9969 -7.59408 +15 2 6.93422 6.24286 1.54682 10.1555 -14.3812 -3.81516 +16 1 16.2065 10.1646 16.1262 8.40668 11.1152 -6.07805 +17 2 17.0895 10.2474 15.7446 -2.7739 -5.15617 3.84543 +18 2 15.9438 11.0841 16.2665 -7.12418 -3.1551 3.11568 +19 1 10.6155 14.9936 2.32061 -1.92123 -0.42827 -4.10202 +20 2 10.587 14.5409 3.17342 -1.90113 -4.17135 2.45193 +21 2 11.1106 15.7965 2.49753 3.42935 4.58062 3.08668 +22 1 17.1538 8.25609 10.4362 5.05968 0.945942 4.2849 +23 2 16.7065 8.97876 10.9029 -1.41924 -5.56537 3.25582 +24 2 18.0123 8.61559 10.168 -2.45464 0.72557 0.389593 +25 1 14.8661 15.8683 16.3562 3.75833 -10.1031 -0.407994 +26 2 13.9609 16.1531 16.2809 -17.2441 8.84265 -1.93831 +27 2 14.8525 15.2671 17.1114 5.79928 3.60638 8.20478 +28 1 12.159 13.3907 0.439783 -6.21112 9.36015 -5.49833 +29 2 12.0312 13.5738 18.1447 5.07318 -6.56614 -2.93527 +30 2 11.6434 14.08 0.875998 -3.18612 -5.19303 11.2101 +31 1 9.2695 5.40921 4.0396 -15.9764 -20.2303 6.13461 +32 2 8.8083 5.02157 4.82949 8.30048 18.0685 -17.5094 +33 2 8.61456 5.30675 3.30783 11.5288 9.4755 11.0493 +34 1 1.82939 4.25621 11.6493 -6.71206 2.38393 -0.709376 +35 2 1.74358 5.20905 11.8686 0.595776 -11.527 -1.23597 +36 2 2.30823 3.82152 12.3665 0.967745 0.8605 0.134832 +37 1 1.98223 6.83069 8.36497 -5.35455 0.0641687 -19.1444 +38 2 2.41924 7.2303 9.11786 5.68758 -2.51321 7.89524 +39 2 2.03012 5.87061 8.47368 0.241822 -0.370612 9.81388 +40 1 5.39801 4.40718 7.93771 10.9733 2.82986 12.12 +41 2 5.47637 3.44759 8.05616 -6.09239 2.90192 -10.948 +42 2 4.7514 4.61131 7.25273 -1.49389 -3.85519 0.176314 +43 1 3.26825 2.92232 17.539 -14.9988 14.8633 6.4114 +44 2 3.91862 3.43305 17.0175 -2.74895 -4.28964 2.11315 +45 2 2.69145 3.57031 18.023 20.6758 -7.505 -11.8237 +46 1 7.47034 5.2735 6.10589 -2.49502 5.37071 -3.04547 +47 2 7.84271 5.98269 6.68437 -5.78386 -20.7203 -0.884416 +48 2 6.94663 4.6123 6.60405 7.6241 17.9385 5.03136 +49 1 9.77266 7.01281 11.9821 10.4665 -1.38292 10.7277 +50 2 10.3585 6.42202 11.517 6.59042 -6.6592 -2.49871 +51 2 9.12807 7.25863 11.3259 -16.7919 6.8996 -8.63143 +52 1 14.096 3.56038 8.06303 -5.03459 -1.11151 -11.1946 +53 2 13.7156 4.24767 7.5046 0.899669 0.845681 1.92473 +54 2 14.4812 4.01512 8.80943 2.7486 3.89851 9.64387 +55 1 4.73966 17.2567 4.00996 -0.195125 14.326 -18.5317 +56 2 5.55163 17.7707 4.1353 -4.1295 -8.09403 5.71009 +57 2 4.38972 17.5915 3.15482 -7.00181 -7.87351 15.3992 +58 1 16.5025 16.6092 10.0733 13.1432 9.20378 8.07617 +59 2 15.9712 16.6856 10.8668 -9.96451 -5.5735 1.54085 +60 2 15.9848 16.1464 9.41138 -7.70063 -5.20479 -0.44901 +61 1 1.97052 4.91045 0.450899 1.06366 9.69844 4.9192 +62 2 2.61093 5.33981 1.06219 -5.49885 -10.5105 -8.09306 +63 2 1.57388 5.6737 18.6422 7.70456 -7.85061 -0.972244 +64 1 11.7662 13.3441 16.2815 -7.88535 5.38496 10.7421 +65 2 11.2704 12.5109 16.442 6.50023 4.10664 -10.6094 +66 2 12.3479 13.2575 15.5066 -9.92493 -12.14 1.82083 +67 1 10.1201 11.0576 16.9389 3.39974 -19.6625 0.923124 +68 2 10.5319 10.1651 17.0061 -5.17122 15.3709 -2.15755 +69 2 9.17725 10.8754 16.8052 5.13113 2.71984 -2.06215 +70 1 11.7111 17.5152 13.4588 11.325 -2.75861 -1.19784 +71 2 12.3718 17.1152 12.8813 -0.632983 -4.36671 1.26506 +72 2 11.9961 18.4406 13.4806 -4.40298 2.90056 2.38202 +73 1 6.35795 9.30394 12.2283 8.95317 6.42027 -9.35456 +74 2 6.91663 9.09838 11.465 -5.59359 -11.5346 -0.139091 +75 2 6.8458 10.0391 12.6013 -0.320164 5.49925 11.3434 +76 1 16.2195 12.7457 2.69542 0.295574 -29.3957 1.13627 +77 2 17.0216 13.1501 2.38091 9.97003 13.3951 -1.47132 +78 2 15.5842 13.4209 2.91145 -9.8096 20.1499 -2.69183 +79 1 0.634077 12.5728 5.88372 -7.9484 2.86768 -4.89493 +80 2 0.988616 12.3569 5.00851 -6.1101 5.76055 1.83916 +81 2 18.334 12.7959 5.71409 15.811 -6.64636 4.43625 +82 1 5.2077 16.407 18.4749 -9.68849 -0.552221 -6.28119 +83 2 5.84718 15.7794 18.0984 2.41425 5.32286 5.94338 +84 2 5.56586 16.8292 0.618687 8.26881 -4.78153 -1.34873 +85 1 0.531249 7.63213 4.08542 33.6963 23.9515 -16.2824 +86 2 18.6021 7.94352 3.35108 5.75308 0.311196 11.7347 +87 2 1.44781 8.03396 3.8909 -38.1012 -20.2476 4.98268 +88 1 3.13519 8.90219 6.5128 -18.1806 -1.10975 19.7922 +89 2 3.61721 8.66647 7.3217 -0.167991 0.711605 -10.7948 +90 2 2.18954 8.88363 6.78472 17.5501 0.713198 -9.35234 +91 1 7.30642 10.3086 16.1993 0.33826 1.86993 11.5423 +92 2 6.5825 10.5097 15.5962 -1.40069 -1.74837 7.12047 +93 2 6.94436 10.2588 17.1142 -3.68695 0.804433 -15.344 +94 1 11.1033 1.05136 4.99998 6.51415 -6.68887 15.4104 +95 2 11.3804 1.86173 4.55399 -8.93638 -1.72916 -9.27788 +96 2 10.7652 0.40817 4.35737 0.804793 8.53975 -5.36269 +97 1 4.41906 2.71829 13.1993 1.75265 -17.8891 31.6776 +98 2 4.61925 3.15892 14.0364 2.0928 12.2335 -7.50334 +99 2 4.34595 1.79439 13.5397 -3.31279 7.49147 -22.0731 +100 1 8.39429 10.0534 1.8011 7.989 6.96853 5.58503 +101 2 8.43083 10.7556 2.48299 -4.47719 -6.35615 -3.34103 +102 2 8.76263 9.25633 2.22388 -6.49712 6.95404 -2.63041 +103 1 10.5097 1.74962 15.5619 -18.3761 -0.922722 7.55335 +104 2 11.4225 1.47346 15.6803 4.80494 4.8298 -6.32182 +105 2 10.3374 2.00269 14.6445 6.81104 -1.01801 -3.49857 +106 1 2.7507 12.9226 7.76103 -0.99391 -3.54814 -5.35437 +107 2 3.2837 13.6196 7.35675 1.026 0.47841 4.16479 +108 2 2.1823 12.6261 7.03948 -5.64928 1.37633 4.69044 +109 1 3.65655 11.6901 5.29539 -1.74666 1.04695 -5.47464 +110 2 3.42979 10.9863 5.91968 -0.390133 2.11749 -7.53732 +111 2 2.90341 11.8434 4.69867 6.59799 -3.91283 3.78854 +112 1 6.86195 14.4839 16.8677 -6.59977 -5.37582 9.26387 +113 2 7.63594 13.9204 16.7929 -0.0312736 1.63672 -3.94334 +114 2 6.43125 14.5303 16.0039 6.73415 3.59122 -3.18668 +115 1 14.1795 14.5536 3.39757 15.4782 -5.44823 -10.5 +116 2 13.7027 15.3725 3.25557 -8.02005 3.41109 -0.200737 +117 2 13.6761 13.9828 3.97966 -5.46722 0.130817 9.75683 +118 1 8.30625 18.1704 16.0558 -18.3501 -5.93921 0.16691 +119 2 8.73243 17.3486 16.3757 13.662 16.7968 -4.53324 +120 2 8.86048 0.311637 15.8745 11.2379 -14.2941 4.19403 +121 1 4.7262 1.6175 4.92485 1.6266 19.4211 -17.3379 +122 2 3.85517 2.05812 4.84475 13.0303 -7.24689 7.72044 +123 2 5.31448 2.15314 4.34837 -14.7695 -11.1634 6.67198 +124 1 15.0789 12.7964 16.4332 -6.30353 8.33681 17.3183 +125 2 14.5699 13.1854 17.1557 10.6035 -4.81202 8.18161 +126 2 14.431 12.7912 15.7403 -5.45963 -10.7064 -24.7799 +127 1 15.7876 18.4014 16.8102 7.97993 -1.6905 34.0366 +128 2 16.3475 18.509 17.631 -13.1355 2.97046 -27.3317 +129 2 15.4303 17.5059 16.9211 5.07282 4.66478 -9.26997 +130 1 1.15379 1.15776 16.5585 8.66192 -1.89028 -5.04545 +131 2 1.90132 1.75074 16.7615 -7.4852 -3.92147 5.78546 +132 2 0.484053 1.2881 17.242 6.61018 5.41271 -0.381602 +133 1 18.0958 4.56873 15.8951 8.25715 -8.22974 -2.59939 +134 2 18.5403 4.03662 15.2192 -4.31028 2.25805 3.56674 +135 2 18.6753 4.5681 16.6654 -3.11748 0.528024 -3.18079 +136 1 12.2229 16.9717 16.1366 4.99185 -14.9968 15.1993 +137 2 11.5697 16.3784 16.5746 6.13992 18.0067 -10.7689 +138 2 12.0903 16.9196 15.1862 -11.661 1.79059 -6.40221 +139 1 15.9175 2.52925 17.9868 -5.04918 24.4496 -1.91719 +140 2 15.7053 3.35036 18.4645 1.43445 -9.55155 0.206063 +141 2 15.6037 2.74854 17.0829 8.19816 -13.208 8.21894 +142 1 6.7035 13.812 10.2396 3.19471 14.7437 0.534165 +143 2 6.61208 13.6203 11.1841 -1.85117 -10.3739 -2.65392 +144 2 6.65674 12.9942 9.7292 -2.15383 -4.24588 3.01674 +145 1 10.13 18.2471 2.79005 6.2323 7.4499 -7.90816 +146 2 10.2641 0.289717 2.1086 -4.88175 -4.44055 6.63338 +147 2 9.27512 17.8471 2.59242 -0.00557908 4.28296 0.85488 +148 1 2.97726 17.7544 6.09154 9.3411 -8.798 -12.7807 +149 2 2.21419 17.6669 5.51339 -17.57 2.09099 8.77855 +150 2 3.67394 17.6484 5.43984 9.00485 8.25893 -0.00709571 +151 1 12.565 16.9537 7.99058 7.14198 1.79921 -4.31208 +152 2 11.8238 16.3251 7.88339 1.67036 10.005 4.65414 +153 2 12.3624 17.6704 8.62526 -6.57036 -14.6618 3.16709 +154 1 14.8823 15.2807 8.26789 -1.91265 -14.526 28.7428 +155 2 14.153 15.9118 8.23916 -2.47753 6.09246 -10.9919 +156 2 15.4304 15.3156 7.48892 0.613021 10.1448 -23.5664 +157 1 17.5919 18.2849 0.376053 -34.2379 -2.64943 -3.08159 +158 2 18.3697 17.8673 0.0312256 25.6277 -7.0964 -1.13253 +159 2 17.798 0.454484 0.829223 12.3697 7.05842 3.85092 +160 1 0.890355 10.3869 1.40531 11.5261 -26.8893 18.421 +161 2 0.106732 9.81739 1.52594 3.68606 12.403 0.666184 +162 2 0.670163 11.0869 0.811123 -14.943 21.2909 -16.3167 +163 1 1.59243 12.2061 3.32787 10.8868 -1.98125 32.4665 +164 2 1.41581 11.4302 2.79423 -4.35317 -0.696655 -17.6875 +165 2 1.68603 12.9921 2.7891 -2.29445 2.46974 -13.9165 +166 1 0.556424 17.2525 4.88159 28.516 -3.31441 -27.2608 +167 2 -0.112492 17.9263 4.93691 -11.7284 7.93843 13.1539 +168 2 0.513874 16.5834 5.55808 -11.2757 -6.6263 16.6148 +169 1 1.11617 0.979823 9.41029 -8.01472 5.90786 -6.49609 +170 2 1.17088 0.754182 10.3385 12.3333 -8.44182 10.8127 +171 2 0.193916 0.78552 9.22994 -1.98368 -3.92324 -6.63209 +172 1 16.7786 2.33534 13.2836 0.301257 -1.02782 -8.61363 +173 2 16.9098 2.55877 12.34 -0.551981 -1.96326 12.3514 +174 2 16.5533 1.39033 13.3371 -1.81134 4.54396 -2.66642 +175 1 2.50838 15.8231 12.1881 11.0759 -0.61625 -4.91684 +176 2 3.05623 15.4799 12.9137 -5.11001 1.87196 -7.11666 +177 2 2.97562 15.6336 11.349 -1.75425 -0.738878 7.05871 +178 1 16.4241 15.5762 5.95419 20.8818 34.7414 3.73321 +179 2 17.3417 15.6388 6.29893 -10.1511 -9.39035 -1.02331 +180 2 16.3256 16.4387 5.46724 -6.92566 -23.7939 4.29358 +181 1 5.82318 5.04015 11.787 7.38202 -1.28642 -1.97288 +182 2 5.53279 5.76584 12.3478 -8.19426 6.74642 1.34004 +183 2 5.25308 4.28957 11.9879 -3.19521 -0.0404241 -0.10221 +184 1 15.2058 4.86095 0.714988 -15.0911 -0.578133 32.6943 +185 2 15.0554 4.65905 1.68214 1.80466 1.09263 -27.7183 +186 2 14.3514 5.22673 19.0716 10.184 -3.76227 -2.57358 +187 1 16.3414 16.3313 2.1188 1.69452 -20.4231 -15.1031 +188 2 15.9696 16.7397 2.89766 0.772445 11.9995 9.83785 +189 2 16.487 17.0139 1.46036 1.64169 8.90638 2.00624 +190 1 0.27953 4.87193 3.80304 22.0083 21.7264 1.42732 +191 2 0.488965 5.84197 3.75834 -13.581 -23.7134 5.51739 +192 2 1.12962 4.47493 4.05501 -10.8528 -1.93786 -0.672788 +193 1 2.93644 15.0118 15.0505 -0.31189 -6.67479 38.4938 +194 2 2.77152 14.5973 15.941 9.17422 6.49202 -18.5047 +195 2 2.6087 15.9081 15.2082 -8.55577 3.59906 -10.383 +196 1 1.11893 14.5977 9.54871 15.5404 -15.1461 3.70851 +197 2 2.05973 14.499 9.39244 4.56619 15.8955 -5.72674 +198 2 0.980037 13.7309 9.94382 -18.1835 3.0763 3.0761 +199 1 13.6623 16.6444 11.5318 -24.61 2.13122 1.95847 +200 2 13.1623 17.4223 11.2076 12.7863 -8.68657 -5.97173 +201 2 13.1098 15.8918 11.2458 9.29846 2.29742 -4.43006 +202 1 4.71401 1.48013 0.724257 -0.188744 -1.90188 8.47653 +203 2 4.10877 2.04213 0.209428 1.54459 -7.39683 1.44825 +204 2 4.1847 0.878426 1.28084 -4.13807 4.124 -10.8706 +205 1 1.4317 18.499 11.8861 -0.747589 2.74228 -9.05649 +206 2 1.26248 0.376362 12.6752 -1.22453 3.10674 7.57799 +207 2 1.76508 17.6414 12.1696 1.67944 -1.01146 1.59049 +208 1 11.5426 10.114 4.08871 14.5973 5.39555 -25.8673 +209 2 11.3947 10.5181 3.18641 4.0612 -8.18021 22.6028 +210 2 12.5241 10.0302 4.19261 -20.6338 4.9276 -1.52234 +211 1 8.35442 12.1679 3.75067 -15.8416 -4.27069 -7.38356 +212 2 9.18656 12.6319 3.95442 -10.6107 -0.215004 12.2135 +213 2 7.67679 12.3128 4.45645 22.0699 3.83678 -6.48541 +214 1 14.3334 4.02625 3.28975 21.4077 6.9275 8.44763 +215 2 15.0849 4.22802 3.89908 -16.2072 -5.96795 -3.3621 +216 2 13.5509 4.49592 3.62574 4.82101 -0.669553 -3.42678 +217 1 5.57933 1.73516 7.50739 -24.0378 -31.7376 11.0088 +218 2 4.91074 1.07012 7.91595 32.7583 31.1537 -18.2093 +219 2 5.45045 1.65908 6.53973 -4.97377 0.997246 11.1506 +220 1 17.8945 1.1186 4.8831 -1.36037 -2.43827 -6.93143 +221 2 18.5804 1.42855 4.26031 -6.60553 2.78724 7.64102 +222 2 17.8025 1.76232 5.59874 4.87877 0.216211 -3.29328 +223 1 6.83024 9.40422 4.48506 -14.9488 0.581331 -12.2421 +224 2 6.75886 9.5424 5.43046 9.61942 2.86103 10.3107 +225 2 7.75214 9.21615 4.27366 4.86133 -4.03573 4.34319 +226 1 2.68867 14.9529 1.96243 -3.68441 -0.0776758 1.15821 +227 2 3.24659 14.6776 2.70632 3.58292 1.9147 -7.42106 +228 2 3.21497 14.9558 1.15083 1.81588 -2.88288 8.16929 +229 1 17.2949 12.8929 13.1574 -7.5849 14.4302 -4.04848 +230 2 16.4401 13.3055 13.2858 -13.783 -13.5119 9.83474 +231 2 17.7157 13.6748 12.8001 24.9453 0.592093 -1.55303 +232 1 15.0095 10.5719 1.38917 -11.2702 -15.2105 -5.46509 +233 2 15.5687 11.2426 1.76309 11.9887 12.322 8.95719 +234 2 14.2298 11.0424 1.10476 -6.47688 3.25886 -0.810136 +235 1 5.70264 6.91192 4.53101 4.96234 -7.94583 8.40724 +236 2 5.98573 7.83684 4.52277 1.36545 -0.678753 -1.4492 +237 2 6.33051 6.43499 5.10591 -2.47306 1.6182 -5.79546 +238 1 8.0801 8.26782 10.1943 -2.48094 -3.5573 30.8197 +239 2 8.76371 8.85191 9.85613 0.308879 9.43682 -13.0265 +240 2 7.56027 7.88877 9.48994 -2.62488 -0.283604 -15.3664 +241 1 13.5 18.3149 5.7974 -5.02979 10.2931 3.81039 +242 2 12.85 0.37996 5.63415 -2.0272 -10.2183 1.79381 +243 2 13.182 17.8392 6.59435 1.6098 2.02728 -12.9685 +244 1 0.276709 2.57627 0.11216 -0.0492842 3.76989 10.2262 +245 2 17.9528 2.7291 18.6895 13.0336 8.33648 -1.41355 +246 2 0.811706 3.36861 0.368499 -21.4808 -7.42382 -6.02819 +247 1 12.6714 10.9997 9.76016 -23.5437 -7.71308 -4.31472 +248 2 11.7133 10.8659 9.59681 15.3229 11.3368 0.532821 +249 2 12.914 10.0869 9.9422 13.3726 -3.72203 6.47581 +250 1 0.779958 12.2601 11.0819 -4.3547 -6.1438 5.62044 +251 2 18.4678 12.2984 11.1653 -6.51403 -1.20026 -7.70008 +252 2 1.07438 12.4529 11.9792 8.34734 4.57522 -3.24255 +253 1 5.0586 7.24501 13.467 -14.0099 -7.28532 -8.10759 +254 2 5.49528 8.03405 13.1289 12.6282 1.90126 -2.15469 +255 2 5.51501 6.98287 14.2704 7.34444 5.85192 6.7727 +256 1 1.26105 6.94281 11.8301 -2.26861 -4.26975 2.97 +257 2 0.502637 7.2894 11.3564 -2.98104 -0.152382 -1.57853 +258 2 1.67901 7.71469 12.2201 5.00338 4.10874 -3.32488 +259 1 15.4732 9.48624 12.3091 -7.90575 31.4836 20.4854 +260 2 15.2888 10.4503 12.3878 3.68649 -17.5592 -11.9783 +261 2 15.3484 9.17907 13.2194 3.56004 -6.14635 -9.9625 +262 1 16.6235 12.9071 5.45115 4.22183 -17.5767 13.0612 +263 2 16.4576 13.8585 5.58703 -5.89626 -6.38642 -16.4082 +264 2 16.4453 12.6107 4.54016 -1.61972 14.741 3.30454 +265 1 6.17978 10.0207 0.140312 6.69901 -0.902574 1.02107 +266 2 5.53175 10.4562 0.704359 -7.04498 -0.0752206 -3.29626 +267 2 6.99223 10.1412 0.643131 5.59964 -6.49227 2.85612 +268 1 12.3558 6.06094 4.04059 -1.82306 -10.4932 18.2897 +269 2 12.2948 6.89378 3.5711 -3.30175 6.87328 -14.7087 +270 2 11.4523 5.72881 4.15047 2.03572 4.51633 -5.92335 +271 1 0.151611 12.8143 0.201399 6.45324 -5.46068 -3.81056 +272 2 -0.0140355 13.4798 0.883392 3.4035 3.37155 -1.9342 +273 2 18.3672 13.1447 18.0414 -1.87626 -1.08321 2.97259 +274 1 3.81145 18.5877 8.5912 1.31461 -3.73146 5.16785 +275 2 3.56882 18.0432 7.82418 -6.49798 6.54364 1.53441 +276 2 2.99788 0.372962 8.89657 -5.11276 -3.31294 -4.1744 +277 1 7.4281 17.2705 4.47377 6.46179 23.4452 -11.2721 +278 2 7.96797 18.0618 4.61565 -3.66399 -5.46425 9.5792 +279 2 7.28703 17.3462 3.52078 -0.310988 -11.8901 2.26571 +280 1 9.22893 17.063 12.2466 22.6161 -18.3078 -0.374418 +281 2 9.25634 16.2959 11.6379 -2.98004 10.6911 5.23864 +282 2 10.0783 16.9759 12.7442 -18.2994 12.1316 -6.13803 +283 1 13.3197 12.9538 7.95187 -9.96581 2.72298 -9.05352 +284 2 13.2593 12.2563 8.62517 4.24613 3.77329 1.00191 +285 2 13.899 13.6706 8.22561 11.1032 -0.425478 9.75376 +286 1 14.9719 2.96045 15.3396 1.81329 0.120121 -0.870248 +287 2 14.3995 2.21229 15.1018 3.59949 7.50345 -3.65154 +288 2 15.6901 3.005 14.6772 -10.8991 -3.85704 4.22675 +289 1 9.85324 15.5257 17.0014 3.97317 -4.57748 -3.47476 +290 2 10.3864 14.7538 16.7592 -3.54516 -0.814303 -2.23392 +291 2 9.2485 15.2429 17.6987 -0.194096 3.36496 6.55889 +292 1 11.2976 8.26736 16.5426 7.06128 19.5884 6.19806 +293 2 10.6048 7.82655 16.0501 -2.15009 -7.46249 -5.1526 +294 2 11.6506 7.64084 17.1804 -3.23764 -5.26669 1.48715 +295 1 3.80261 18.1891 16.7286 5.96532 3.63646 9.58286 +296 2 4.2558 17.5705 17.3068 2.57751 -13.4277 -2.28373 +297 2 3.88923 0.356458 17.2317 -6.08372 7.81341 -6.39572 +298 1 2.19516 4.11859 8.94937 -6.46461 1.56382 -5.27436 +299 2 3.07192 3.77694 8.7043 -7.24867 0.753394 12.5906 +300 2 2.01364 3.98399 9.90559 16.1239 2.6739 -11.0998 +301 1 9.88488 10.3605 9.72172 5.12637 14.4569 -2.91242 +302 2 9.60959 11.2332 9.33432 -0.0101703 -19.6763 14.6837 +303 2 10.1282 10.4603 10.6632 -8.0115 2.48909 -7.97128 +304 1 9.71465 0.804575 10.8512 21.7431 15.3431 10.1505 +305 2 9.2832 18.6897 11.2643 -8.53487 -4.69507 -4.97966 +306 2 9.18676 1.22081 10.1628 -13.1132 -5.80645 -3.94121 +307 1 9.20675 15.1716 10.2106 -23.935 -1.88548 4.57185 +308 2 8.85892 15.9372 9.71979 2.38257 -5.68301 1.50138 +309 2 8.39577 14.638 10.4071 17.7258 6.53325 -11.5344 +310 1 1.0072 9.34307 10.3251 -13.5607 -2.30165 -2.87521 +311 2 1.0259 10.3094 10.4263 12.3488 -1.76633 0.307332 +312 2 1.88127 8.96784 10.1532 -1.03643 13.7416 3.72628 +313 1 16.8438 4.87108 8.18901 -4.78961 0.896955 11.5039 +314 2 16.1406 5.46499 8.54396 15.0863 -10.4307 -3.41532 +315 2 17.2081 4.33923 8.92353 -6.78534 8.8584 -10.8667 +316 1 14.6587 14.7041 0.366828 1.30507 -0.478814 3.63059 +317 2 15.185 15.0332 1.12636 -7.04307 -0.464202 -11.0373 +318 2 13.8385 14.3426 0.742198 8.82268 0.591631 -2.33039 +319 1 3.54036 11.0513 9.61487 2.50715 2.61524 -7.45538 +320 2 3.63629 11.5626 10.435 -2.71976 -6.10697 -0.243655 +321 2 3.06413 11.634 8.99273 6.16009 -0.263385 5.30284 +322 1 11.0628 10.8412 1.29387 1.94664 2.31063 1.36488 +323 2 11.3352 11.6508 0.816723 -4.4237 -7.82009 8.11802 +324 2 10.1138 10.7005 1.1254 8.25661 2.0034 -0.662671 +325 1 13.2071 7.092 12.8743 -8.181 6.96481 -7.78695 +326 2 14.1492 6.89693 12.9368 4.59729 -0.0390769 -2.26511 +327 2 12.7747 6.23567 12.7699 0.0352738 -4.27477 4.68983 +328 1 9.62872 1.89049 0.957357 1.17656 -1.16236 13.2501 +329 2 8.73134 1.77169 0.632677 -1.73422 -2.0126 -6.33446 +330 2 10.2301 1.88378 0.211292 -0.739962 2.15457 -7.7161 +331 1 10.5914 13.525 4.7165 6.94092 6.03141 -14.7136 +332 2 11.5001 13.1966 4.5902 -6.55933 -2.4681 12.9436 +333 2 10.616 14.067 5.5206 3.43098 -5.16043 -1.25188 +334 1 14.3018 1.72484 10.9172 13.4371 11.1223 -9.93713 +335 2 15.1272 1.43467 10.5035 -1.81024 -10.6133 4.43081 +336 2 14.4134 2.68551 10.8564 -6.433 0.422524 6.62217 +337 1 14.6521 12.3877 11.7022 -8.45049 -6.71538 5.80805 +338 2 15.5103 12.5052 11.2413 -17.7577 -5.57988 -7.54306 +339 2 13.9188 12.0751 11.1197 22.5147 4.82958 0.534535 +340 1 8.2427 5.06906 9.80652 6.55588 21.6544 3.19941 +341 2 7.41824 5.23391 10.2944 2.41744 -11.9303 -3.89737 +342 2 8.21758 4.20856 9.37923 -10.585 -10.7296 4.55255 +343 1 1.58459 16.8369 18.3321 1.96955 3.78018 0.59611 +344 2 1.85004 17.2184 17.4898 0.0469727 3.49377 1.52109 +345 2 1.98826 15.9645 18.3052 -5.87072 -8.1408 0.0386171 +346 1 1.45085 17.2397 15.3384 19.3024 -11.6024 -7.75777 +347 2 1.52928 18.1033 15.7334 -7.82156 13.9033 4.46915 +348 2 0.523156 17.01 15.2404 -5.15812 1.64021 5.22009 +349 1 3.71432 5.60797 6.16821 -6.42766 23.1509 5.2389 +350 2 3.10788 6.20238 6.65309 4.74203 -10.8724 -0.844938 +351 2 4.31902 6.23597 5.73943 -0.58891 -7.80382 -7.69424 +352 1 12.3617 9.44178 14.1897 14.768 -21.5294 -7.13739 +353 2 12.6854 8.60646 13.7318 -7.61852 23.4532 21.1317 +354 2 12.1886 9.19254 15.1239 0.0190459 -2.13671 -14.4759 +355 1 4.02789 15.2847 6.90037 19.6963 3.91174 -8.53909 +356 2 3.59813 16.0446 6.4807 -5.57314 -2.58109 7.58101 +357 2 4.98627 15.4174 6.72455 -14.0806 -2.64155 5.91133 +358 1 0.604694 8.56382 14.8836 6.38519 14.8729 2.46932 +359 2 0.593576 9.52815 15.0331 -4.38489 -7.16014 1.99766 +360 2 1.21683 8.48632 14.1406 0.0450847 -3.26888 3.80333 +361 1 12.9907 8.33553 10.3435 -10.7244 11.0212 -25.595 +362 2 13.7217 7.85043 9.92864 1.48882 -4.14748 10.5805 +363 2 12.916 8.06476 11.2563 9.06532 -10.0671 12.5191 +364 1 15.3021 7.67479 3.50456 -15.706 -31.6797 19.6454 +365 2 14.5991 7.08356 3.22123 -2.84665 13.9574 -20.9494 +366 2 15.4859 7.21773 4.34079 18.8178 22.1978 3.49889 +367 1 17.3057 6.66581 0.0439089 -0.566439 -0.157214 -4.14934 +368 2 16.9415 5.80914 0.322205 -4.36129 9.908 -1.962 +369 2 16.5386 7.21525 18.4101 8.51434 -8.37768 3.91558 +370 1 8.82219 6.93132 7.84612 -10.1525 -9.67927 6.48857 +371 2 9.74438 7.17539 7.82243 13.4851 9.91198 -3.74634 +372 2 8.75511 6.31699 8.60098 -3.86074 2.18846 -4.69843 +373 1 12.3417 0.621389 1.18077 -6.9564 -3.41972 6.83906 +374 2 13.1525 0.726993 1.70017 3.48999 0.0677543 -9.59522 +375 2 12.4857 18.5505 0.551479 3.63823 3.88808 0.842467 +376 1 5.6677 15.1168 14.5202 -2.89809 14.409 3.62726 +377 2 4.73779 15.2069 14.7798 -2.10515 -4.92641 -4.42493 +378 2 5.95698 16.02 14.2745 1.37709 -12.0745 -2.57764 +379 1 3.85174 6.50812 1.71549 -1.87326 -9.92841 -7.94113 +380 2 3.40118 7.27684 1.32447 4.40945 3.56133 7.79633 +381 2 3.98293 6.6854 2.65555 -2.72837 5.07562 -0.486349 +382 1 3.88774 11.6179 12.2731 7.36248 2.53406 3.74193 +383 2 4.74563 11.9961 12.5096 3.21135 -1.44769 -3.24982 +384 2 3.26188 12.2215 12.6852 -7.1456 -2.35069 3.20446 +385 1 5.4326 3.86602 15.8669 5.46195 27.5847 5.5501 +386 2 6.12196 3.19729 15.7751 -0.292732 -1.96119 -5.07149 +387 2 5.89955 4.7414 15.9262 -11.6823 -23.746 -2.53289 +388 1 14.4519 10.31 4.40466 -0.198609 -22.4452 -14.1251 +389 2 14.647 9.76314 5.18938 0.972168 3.21729 -6.37484 +390 2 14.6939 9.77999 3.59617 -3.45576 13.8176 24.0335 +391 1 7.91012 17.3396 9.21881 -3.47249 -5.09989 3.31179 +392 2 7.12992 17.5549 9.76562 5.48476 5.05439 -11.164 +393 2 8.00718 17.9294 8.44912 -7.46491 1.16212 7.11091 +394 1 4.51961 14.4455 3.97665 1.46094 13.6517 19.4367 +395 2 4.57851 15.3966 4.28178 1.46521 -27.5553 -6.05216 +396 2 4.65578 13.8277 4.74009 -3.41874 17.0045 -15.0106 +397 1 14.2914 7.39173 15.7568 2.67151 4.01398 13.8033 +398 2 15.2382 7.26829 15.5879 -5.04223 1.8615 0.0507223 +399 2 14.2621 7.71182 16.6758 1.37252 -0.910778 -10.0112 +400 1 2.89282 18.2219 1.89623 16.0954 20.7868 19.4211 +401 2 2.43498 17.5738 1.38145 -10.8581 -14.0242 -17.961 +402 2 2.20473 18.7378 2.33948 1.00824 -0.59586 0.163903 +403 1 7.97772 1.60288 4.53639 1.7563 -9.68985 13.008 +404 2 7.31922 2.029 3.97737 7.04095 6.46018 -8.6135 +405 2 8.84264 2.02013 4.43356 -4.53303 1.60821 -5.92451 +406 1 2.59943 14.1332 17.7414 -8.95394 -18.2677 -2.38171 +407 2 1.94944 13.4122 17.9464 12.5244 20.6844 1.19004 +408 2 3.47205 13.7759 17.9983 -8.8914 0.728457 0.900702 +409 1 0.745112 1.69912 13.8711 11.2473 3.52367 -11.146 +410 2 0.914419 1.4049 14.7673 -7.77297 1.70239 6.88788 +411 2 18.4589 1.93825 13.7842 -0.334419 -0.897106 4.15254 +412 1 4.53599 18.6175 13.9535 -3.4557 6.59794 -4.70782 +413 2 5.46815 18.3485 13.9788 -8.18255 -2.00556 -1.03369 +414 2 4.11637 18.3402 14.7801 5.6735 0.958275 2.99437 +415 1 7.096 0.531319 18.3551 -0.694611 7.4496 8.80978 +416 2 7.23097 0.178113 17.4735 2.95576 -3.96306 -6.42653 +417 2 6.14085 0.633472 18.4745 3.33236 6.58102 0.363951 +418 1 16.0915 18.4336 14.0959 0.427379 -0.396215 -8.58483 +419 2 15.3508 17.8946 13.7703 3.59427 8.97013 10.1541 +420 2 15.9721 18.7209 15.0186 -4.35198 -12.8399 -3.85995 +421 1 10.0849 4.5187 16.2702 4.73223 -5.50586 5.92697 +422 2 10.9866 4.63155 16.5807 5.77761 8.19399 -3.69287 +423 2 10.0461 3.5611 16.1717 -6.80252 -1.66686 -4.51665 +424 1 15.8725 17.8845 4.41654 -12.5209 12.7326 5.37596 +425 2 16.3916 18.7124 4.49019 -1.68969 -11.5252 -1.94643 +426 2 14.9593 18.1341 4.67479 17.449 -5.50076 1.40971 +427 1 6.95668 17.3709 13.7302 27.0332 5.97859 23.7699 +428 2 7.35597 17.5596 14.624 -6.60353 0.436933 -26.7426 +429 2 7.73328 17.3113 13.1176 -17.9234 -0.691624 11.5164 +430 1 13.2886 6.54141 6.708 -19.4099 -8.32294 21.4331 +431 2 14.1944 6.83212 6.62317 10.4169 5.52785 -11.9279 +432 2 12.8902 6.38702 5.85009 7.8467 0.777822 -14.5162 +433 1 7.70655 2.38278 9.20977 12.6343 0.60353 -10.8933 +434 2 7.2325 2.23152 10.0347 -6.87682 0.627979 2.4454 +435 2 7.14224 2.1131 8.46352 -1.96859 -1.38987 10.9664 +436 1 15.1599 14.8609 13.6555 2.14917 -2.72077 3.1958 +437 2 15.0894 15.1454 14.5818 -4.10533 -0.470809 -6.08849 +438 2 14.3857 15.1548 13.1581 4.50097 1.9243 4.2209 +439 1 9.31836 8.32368 3.71602 18.5592 -2.51714 11.5674 +440 2 10.1335 8.79007 3.99631 -8.14035 -3.14117 -4.90658 +441 2 9.4898 7.3827 3.90713 -7.2783 5.8685 -3.93333 +442 1 17.7186 13.4905 16.4359 -1.51289 22.2408 -13.156 +443 2 16.7625 13.3639 16.3649 1.62841 -7.26982 3.16217 +444 2 17.8329 14.3608 15.9953 4.68582 -10.1291 6.26608 +445 1 5.02763 10.6563 2.64305 -2.13744 -9.22816 3.31541 +446 2 5.67739 10.1782 3.18798 -3.0773 8.85482 -0.1212 +447 2 4.59818 11.3042 3.21285 3.70326 -1.5106 2.19329 +448 1 3.72149 8.34459 10.2919 -0.179455 -7.68631 -12.7595 +449 2 3.82782 9.26393 10.0171 0.460185 9.10653 3.72446 +450 2 3.7984 8.31763 11.2506 0.24707 1.5831 -0.943414 +451 1 16.0782 7.09232 6.27704 3.78536 -20.3998 -1.61032 +452 2 16.8668 7.5306 6.63092 -6.12864 4.03671 -1.53431 +453 2 16.2929 6.14181 6.32149 -2.48234 12.3559 -4.92911 +454 1 15.1572 7.02511 9.10581 3.8117 16.1939 -22.7388 +455 2 15.9823 7.33517 9.52567 -10.9007 1.4123 -2.48218 +456 2 15.0452 7.59247 8.29613 6.45133 -12.7204 22.5185 +457 1 6.42341 13.1088 12.8743 -8.95622 -6.97199 -8.56847 +458 2 7.13157 12.5608 13.2501 0.579484 9.04377 -2.95583 +459 2 6.27581 13.8943 13.4207 1.62934 -6.42573 5.92996 +460 1 12.1251 4.48872 13.0852 20.6978 11.8008 -11.4801 +461 2 12.1861 4.63134 14.0408 -7.38726 -2.06828 2.45652 +462 2 11.3124 4.06154 12.8314 -12.072 -7.43803 9.29181 +463 1 11.3394 8.19587 7.85205 11.1059 -10.4301 17.8484 +464 2 12.0348 7.61277 7.52234 0.357557 0.521252 -13.0071 +465 2 11.6101 8.269 8.78041 -6.91702 7.4869 -1.95681 +466 1 17.1867 10.7889 7.4395 14.5297 -2.81026 -23.5185 +467 2 17.9096 10.1869 7.16109 -12.9834 1.71839 15.1597 +468 2 17.0415 11.3048 6.62611 -4.1729 8.16775 12.482 +469 1 5.24074 18.1281 11.0581 -15.2173 -3.98599 -8.34189 +470 2 4.58924 18.0057 11.7782 10.2636 1.95052 -8.13419 +471 2 4.73144 18.0737 10.2167 7.33147 4.07832 13.9505 +472 1 7.57528 17.5815 1.8237 -4.07192 12.6902 15.9513 +473 2 7.93668 16.805 1.40258 -2.93669 -7.99436 -16.24 +474 2 7.56667 18.3008 1.17772 -1.22407 -7.09592 -6.98677 +475 1 1.89335 12.9293 13.6081 -2.83392 -4.38044 7.70492 +476 2 1.42634 12.2947 14.1785 7.13969 5.03303 -2.73416 +477 2 2.14611 13.6729 14.1857 -2.01709 -2.63559 -9.61881 +478 1 9.71667 6.79197 14.8165 -19.737 27.0922 8.68981 +479 2 9.89359 5.91802 15.1417 7.60675 -24.7177 2.15595 +480 2 10.032 6.8882 13.9194 5.10262 -3.22926 -9.37061 +481 1 15.2334 4.35765 10.7756 -27.5978 -16.2477 -22.3588 +482 2 16.1684 4.22394 10.6591 16.9939 1.30069 13.5789 +483 2 15.041 5.04225 11.4098 10.4595 11.1452 11.1309 +484 1 11.214 6.13659 0.181715 -19.0514 -14.6776 -12.5318 +485 2 11.2124 5.17659 0.0304417 14.0569 6.29109 5.62342 +486 2 10.2823 6.34718 18.6411 6.7491 10.3457 6.1137 +487 1 0.148583 11.3373 15.1258 -19.5821 15.0001 -24.2151 +488 2 18.1981 11.6758 14.382 16.6378 -5.64999 24.2973 +489 2 18.7581 12.0391 15.8029 -7.9684 -6.15355 -5.02438 +490 1 7.07881 9.17505 7.27008 -6.43803 -1.74166 -4.58486 +491 2 6.45798 8.45812 7.48524 7.10939 3.15379 4.24177 +492 2 7.95401 8.76045 7.26417 -3.66954 2.28396 2.09633 +493 1 18.4168 15.4276 12.3546 -3.43386 -0.549873 -4.48624 +494 2 0.729474 15.5504 12.2627 0.527014 -4.05801 2.94094 +495 2 18.0745 15.7474 11.5108 -2.98934 0.409485 0.218187 +496 1 16.554 4.36499 5.23729 20.8954 -6.05263 25.9175 +497 2 16.7683 4.14077 6.16822 -16.8827 1.59137 -12.628 +498 2 17.4495 4.42836 4.87212 -5.6372 6.04853 -15.3532 +499 1 17.7678 3.07292 10.7257 -2.33819 12.1961 -2.64827 +500 2 0.05876 3.27172 10.9273 -5.50289 -7.01135 -0.383438 +501 2 17.6798 2.21428 10.2822 5.02163 -0.151153 2.81987 +502 1 12.2925 0.0394171 10.1485 -5.03026 26.5344 11.6637 +503 2 11.4572 0.407352 10.526 9.87088 -12.259 -12.5756 +504 2 12.9102 0.803778 10.1803 -6.63246 -15.2789 0.0865208 +505 1 10.3587 9.80679 12.3603 15.6128 10.3756 0.750657 +506 2 11.1656 9.89562 12.9016 -9.14674 -1.49827 1.04164 +507 2 10.2822 8.8615 12.2126 -4.78815 -8.04326 1.85351 +508 1 0.512396 2.83902 7.01376 3.84696 0.0782361 15.1378 +509 2 0.640445 3.53836 7.66576 0.959953 5.26089 -8.6545 +510 2 0.680944 2.06786 7.56376 2.06531 -6.50055 -6.8896 +511 1 0.435055 15.2675 6.92024 15.2549 -35.398 4.87844 +512 2 0.621058 15.2814 7.87767 -6.30652 4.63478 -5.55491 +513 2 0.767833 14.3496 6.68755 -16.1257 30.2961 -2.9732 +514 1 16.9932 7.01767 15.3053 -26.5651 1.45521 -6.17716 +515 2 17.7481 7.60304 15.1777 11.1425 -6.61607 -1.97906 +516 2 17.2478 6.0923 15.4082 16.5215 2.79636 5.68328 +517 1 9.018 12.4253 8.12635 6.95093 19.302 15.9025 +518 2 9.42759 11.8305 7.48541 -10.9396 -6.20971 -13.8418 +519 2 8.05723 12.5431 8.02215 9.94353 -10.4145 -8.12359 +520 1 1.2603 1.92339 3.03777 4.00037 -11.2111 -0.333139 +521 2 0.985763 2.4239 2.25859 3.27899 1.87382 4.37683 +522 2 1.94434 2.40743 3.53125 -8.95634 4.24445 -6.71947 +523 1 4.13152 15.1081 9.6737 -15.9579 5.42681 13.2475 +524 2 4.06185 15.276 8.72578 6.37214 -2.02945 -0.454299 +525 2 5.01049 14.775 9.87491 6.77649 -3.08542 -5.82222 +526 1 7.18656 2.18024 14.5742 6.63684 0.423238 1.66106 +527 2 6.97291 1.78224 13.7284 -0.102066 -5.66692 0.745345 +528 2 7.71431 2.94579 14.3335 0.160548 4.26015 2.86325 +529 1 18.6004 14.6938 2.16823 2.76542 -5.02319 -0.780568 +530 2 0.802927 15.1539 2.18876 5.80577 -4.93168 -0.456722 +531 2 17.9585 15.3989 2.13554 -15.1748 6.08707 3.47143 +532 1 9.94779 2.77101 12.9402 13.7079 -4.8088 0.992354 +533 2 9.86912 2.18708 12.1681 -6.43941 0.85112 1.08944 +534 2 9.26112 3.44421 12.9098 -9.63803 -0.00730006 -3.05418 +535 1 2.82654 8.93218 13.0337 -16.8853 -9.00607 0.122573 +536 2 3.25687 9.752 12.7946 6.59476 15.835 -2.70012 +537 2 3.50997 8.32082 13.3007 12.5319 -6.06263 8.37491 +538 1 3.22862 8.37837 3.65188 -0.226515 1.69475 29.0088 +539 2 3.688 9.03214 3.10752 1.26352 6.15003 5.24259 +540 2 3.37942 8.56962 4.62044 0.873457 0.138782 -29.442 +541 1 5.6209 7.19208 8.52428 9.74274 9.28918 -7.76376 +542 2 5.82768 6.24803 8.58864 -11.1579 -1.95789 2.42461 +543 2 4.98617 7.45468 9.2041 -0.288223 -8.23268 4.91577 +544 1 14.8711 1.29057 2.00464 8.31119 17.2873 -6.28041 +545 2 14.835 2.11415 2.48745 -9.33397 1.40045 17.6104 +546 2 15.2356 1.62076 1.17953 -0.998754 -14.9614 -12.238 +547 1 8.25883 15.2026 0.830681 5.29747 -5.49957 9.6471 +548 2 8.95156 15.1522 1.50066 13.8019 -1.55539 -6.59484 +549 2 7.5748 14.6468 1.22478 -8.81297 0.605757 -6.77665 +550 1 15.6232 1.34362 7.23598 -18.647 -1.91314 -11.6656 +551 2 14.9897 0.764646 6.76092 12.0508 5.58891 7.1025 +552 2 15.1447 2.18632 7.33027 3.5178 -4.19741 5.22167 +553 1 4.94904 13.0769 18.5237 9.6722 0.589191 0.374268 +554 2 5.36668 13.208 0.749415 -4.04426 -2.7658 -6.21312 +555 2 5.63686 13.3362 17.8955 -3.04446 1.7017 1.4528 +556 1 15.3696 8.47999 18.1528 -1.21138 17.1653 -12.6794 +557 2 15.695 9.10606 17.469 -1.13375 -12.9806 6.06144 +558 2 15.1122 9.07709 0.225504 3.72099 -3.98362 5.25331 +559 1 12.0892 3.03182 18.3639 -14.1234 30.4246 -7.06661 +560 2 12.0418 2.65673 0.600248 11.0312 -14.2758 -1.1161 +561 2 12.4684 2.43863 17.7097 5.58993 -13.4699 6.64437 +562 1 13.2076 12.6677 5.18878 -11.1257 12.6934 -18.8931 +563 2 13.6382 11.873 4.85103 6.50507 -2.50005 7.23376 +564 2 13.4408 12.7972 6.11334 1.90386 -8.97209 5.02297 +565 1 6.04179 7.07685 0.0416979 2.64097 -12.2137 0.441028 +566 2 5.97681 7.98433 18.9573 -0.86164 23.926 -2.06041 +567 2 5.22747 6.68409 0.369779 -2.28588 -4.24693 2.31783 +568 1 17.7316 15.9939 15.0114 -15.9363 1.83518 -2.01139 +569 2 16.8954 16.4456 15.035 -7.98632 8.38962 22.0218 +570 2 17.7728 15.8943 14.0703 21.4922 -14.9825 -23.1623 +571 1 13.1856 0.993654 16.5812 4.51688 -6.04585 -7.39508 +572 2 14.1484 0.841574 16.6066 -7.22778 -1.30407 6.3933 +573 2 12.7998 0.141541 16.3207 3.39554 1.08214 8.76474 +574 1 11.0918 14.5789 7.23122 -0.0827639 9.53574 4.16562 +575 2 10.4295 14.1218 7.74457 -13.7426 -4.81361 3.6986 +576 2 11.9118 14.1808 7.52276 7.59678 -9.08814 -4.3045 +577 1 17.5016 8.6119 2.09076 15.8147 11.2146 7.10458 +578 2 16.6678 8.4072 2.52184 -8.49554 -5.1851 -0.954934 +579 2 17.6089 8.02126 1.34907 -7.08963 -15.2245 -7.94382 +580 1 12.3468 7.97644 1.98939 8.16003 1.60059 13.0036 +581 2 12.1059 8.91014 1.92161 -4.12319 -5.14517 -8.91961 +582 2 11.9653 7.48445 1.25112 -3.43761 0.267259 -0.201848 +583 1 11.9018 14.6174 10.3415 -1.61415 6.01794 0.545715 +584 2 12.1103 13.7968 9.87035 -7.85836 7.68399 3.13223 +585 2 10.9576 14.8558 10.2015 13.8599 -12.9225 1.87067 +586 1 6.88302 7.0351 15.5985 0.0361083 -3.88964 -3.36213 +587 2 7.78537 7.14813 15.233 -9.24764 2.66089 10.2853 +588 2 6.74206 7.63616 16.3488 6.91006 -2.15529 -8.72434 +589 1 7.99721 4.71198 13.4628 5.66523 -8.00363 0.660216 +590 2 7.27921 4.81457 12.8289 -1.54019 0.966988 -4.0678 +591 2 8.48375 5.53924 13.4635 -1.88422 3.21799 -0.709238 +592 1 13.4036 12.1691 14.2716 3.14721 5.94494 7.46154 +593 2 13.2707 11.2057 14.207 -2.45791 4.15826 -3.3873 +594 2 13.8696 12.4652 13.4742 -1.1423 -6.74147 -2.23487 +595 1 14.8179 9.43426 7.29668 -6.36233 -11.9657 -8.30628 +596 2 15.5946 9.98871 7.43973 -1.00608 2.08043 5.84882 +597 2 14.0417 9.81939 7.70717 2.29675 7.38462 3.05591 +598 1 12.6631 17.0342 3.08686 -0.647851 26.0284 13.2632 +599 2 13.0189 17.4392 3.9047 -6.62985 -13.126 -8.67274 +600 2 12.0984 17.7464 2.72355 6.77056 -16.0012 0.625123 +601 1 1.16659 7.14982 17.4488 -22.2539 0.168591 -14.6305 +602 2 0.289944 6.86023 17.7803 4.99818 12.4666 0.0121858 +603 2 0.976074 7.62854 16.6106 6.60301 -8.93429 9.27073 +604 1 12.7913 5.13723 15.6659 26.8924 -5.83385 4.65231 +605 2 13.5397 4.50448 15.7352 -14.8898 5.20509 -1.35689 +606 2 13.2524 6.00122 15.6738 -9.3883 -7.24139 -3.09335 +607 1 2.50717 3.39641 5.02544 -4.94238 4.99772 43.075 +608 2 1.86502 3.10611 5.74586 16.3729 8.7954 -24.7542 +609 2 3.07143 4.08677 5.47722 -17.3542 -15.0389 -19.8763 +610 1 8.33721 11.2536 13.4671 -31.8218 12.3906 11.8554 +611 2 8.27902 11.0779 14.4347 20.4393 -8.01279 -19.4916 +612 2 9.11607 10.9377 12.9927 6.53682 -12.2231 14.6875 +613 1 12.8982 1.36842 13.3393 -2.38428 13.9081 -24.9925 +614 2 13.3657 1.32357 12.4816 4.13856 -5.14841 14.3736 +615 2 12.4149 2.20238 13.2267 1.28817 -6.58848 11.7421 +616 1 6.36101 13.6632 2.13728 5.84509 3.64922 20.165 +617 2 5.80267 14.0802 2.81815 -1.42815 -2.61112 -9.48922 +618 2 6.96781 13.1347 2.6793 2.58248 -4.73497 -8.11447 +619 1 15.9275 6.58906 12.776 -13.2255 -11.9143 -7.63467 +620 2 16.5079 7.05171 12.1721 3.66176 7.36442 -5.52267 +621 2 16.2877 6.70509 13.653 8.87525 3.50761 9.55012 +622 1 16.8403 0.7053 9.59425 -10.8287 -6.51914 0.180126 +623 2 16.6786 18.4058 9.8215 7.5744 10.512 -7.34073 +624 2 16.3431 0.86575 8.76743 6.96547 -2.88011 1.97602 +625 1 6.14042 11.7236 8.37935 -13.4401 -40.1875 -12.4491 +626 2 5.21965 11.5178 8.67227 17.9013 7.59491 -1.88002 +627 2 6.47134 10.8481 8.01351 -3.81201 28.7474 13.2691 +628 1 2.85976 8.65216 0.41009 29.1416 -12.2873 -0.261225 +629 2 2.35956 8.19684 18.3517 -12.3126 13.3733 12.5274 +630 2 2.40304 9.34487 0.902258 -18.8466 -1.4582 -10.1697 +631 1 10.1473 10.4614 6.51315 3.14709 -2.48115 -1.63688 +632 2 10.5898 9.76783 7.02035 -1.8228 -0.602608 0.477386 +633 2 10.6086 10.4674 5.65949 -3.20151 3.83187 3.87642 +634 1 6.7508 15.7003 6.55579 -3.66232 16.9823 8.74149 +635 2 7.17195 16.1106 7.3235 -0.889674 -7.99055 3.10182 +636 2 6.78205 16.4211 5.90999 7.33374 -8.97986 -9.58603 +637 1 6.44532 13.1371 5.60194 -4.00449 -9.15456 -0.382904 +638 2 6.60496 14.011 5.98141 3.67218 -1.64471 2.17047 +639 2 6.02503 12.5975 6.28414 2.5909 4.19611 1.89612 +640 1 16.8064 12.5561 9.82402 0.581653 -6.91502 5.14494 +641 2 16.9779 11.8749 9.14515 -1.61791 10.9714 -1.54419 +642 2 16.8208 13.4318 9.41997 2.06437 -4.78596 -5.13994 +643 1 6.05928 2.9442 2.82556 1.25802 -7.30262 2.82421 +644 2 6.27309 3.83898 2.57954 7.79966 17.9541 1.71249 +645 2 5.71238 2.57735 2.0082 -4.75947 -10.8151 -3.84195 +646 1 10.8984 3.29285 3.29228 5.15622 -3.79068 5.20633 +647 2 10.3299 4.01236 3.59418 -0.748764 -1.25701 -6.51467 +648 2 10.5397 2.95527 2.46424 -5.70132 0.188995 -0.608043 +ITEM: TIMESTEP +30 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.74009 7.04233 17.938 19.1777 -3.19214 -7.49225 +2 2 7.80649 7.00854 18.1244 -14.093 -2.50808 3.42214 +3 2 8.91581 6.41795 17.2214 -5.10918 0.448792 4.2696 +4 1 18.6171 8.27942 6.83462 -12.32 14.9255 -3.46236 +5 2 0.0642234 8.14825 5.88022 8.8384 -8.96826 -1.74433 +6 2 0.471057 7.61284 7.31078 8.78566 -8.6497 2.36561 +7 1 8.41948 18.604 6.83196 -7.31709 9.89495 0.0475112 +8 2 9.31705 0.18142 6.57583 5.64527 1.22556 -0.782264 +9 2 7.87491 0.677395 6.4693 3.49499 -4.79599 0.294282 +10 1 6.58709 1.81441 11.6738 -9.76955 10.2882 13.9968 +11 2 5.91112 2.25954 12.2323 7.89399 -9.20897 -13.0604 +12 2 6.23103 0.933026 11.5157 -4.21921 -5.78552 -0.720022 +13 1 7.09426 5.71845 2.37594 5.34919 -15.1759 8.94595 +14 2 6.67772 6.26147 3.06365 -7.93287 1.62685 -13.8275 +15 2 6.91151 6.0744 1.49958 -5.30903 10.9181 0.766926 +16 1 16.2033 10.1932 16.1102 25.1038 -14.8345 -4.68499 +17 2 17.1811 10.2276 15.9712 -26.7737 6.31541 3.48142 +18 2 15.8826 11.0697 16.3304 -0.495148 7.87416 1.92317 +19 1 10.6275 14.9681 2.33481 4.63974 12.4061 -8.88569 +20 2 10.5525 14.5877 3.21874 0.475518 -3.93386 2.29786 +21 2 11.1735 15.7673 2.45016 -5.17002 -7.496 3.37274 +22 1 17.1558 8.25893 10.4932 -6.40301 -0.466841 8.61163 +23 2 16.8014 9.01233 11.0035 2.41501 -9.01393 -1.96838 +24 2 17.9838 8.5563 10.1014 3.2569 5.37409 0.738347 +25 1 14.813 15.8567 16.3841 0.422148 6.97991 -3.34819 +26 2 13.9021 16.1825 16.382 -1.86689 -1.60487 0.125842 +27 2 14.9304 15.3999 17.2268 -3.27081 -1.81494 5.72738 +28 1 12.1434 13.4089 0.461034 6.76243 -11.3039 1.90058 +29 2 12.0273 13.3364 18.1404 -4.47443 10.9984 5.76772 +30 2 11.5266 14.0334 0.870976 -2.78837 -1.53089 -3.65161 +31 1 9.27697 5.43199 4.02458 -7.91052 -7.29997 -7.2337 +32 2 8.84655 5.10212 4.83549 0.848683 4.58319 -8.36746 +33 2 8.59135 5.35221 3.31849 12.3251 4.32217 11.9863 +34 1 1.81829 4.21991 11.6429 6.07059 -17.107 12.3126 +35 2 1.72876 5.16246 11.8251 -3.56412 5.27463 0.970751 +36 2 2.25117 3.81723 12.4298 -6.51129 5.35444 -16.475 +37 1 2.00161 6.82001 8.34658 4.25884 -4.64897 6.26816 +38 2 2.3883 7.2423 9.12712 0.123274 4.2764 -6.11357 +39 2 2.06217 5.87963 8.57415 -6.89287 0.824976 -4.38383 +40 1 5.40511 4.42179 7.95561 5.36611 -11.1614 7.9457 +41 2 5.37943 3.4545 8.00651 8.07147 0.734095 -1.60012 +42 2 4.74745 4.62621 7.29567 -7.31573 12.7226 -8.35968 +43 1 3.27976 2.92717 17.5269 -2.61436 17.3567 -5.43199 +44 2 3.96706 3.40529 17.0145 -5.77518 -10.9103 1.73426 +45 2 2.73687 3.63363 17.9263 6.62302 -5.15647 1.61932 +46 1 7.46558 5.28438 6.08942 -8.18758 20.8516 25.3808 +47 2 7.86532 6.07017 6.49581 9.60667 -5.12281 -7.79846 +48 2 6.93507 4.98822 6.84771 -4.13165 -15.5457 -12.384 +49 1 9.77734 7.00329 11.9774 4.77277 1.25087 12.6605 +50 2 10.3838 6.43919 11.4894 -2.2356 -0.795019 -4.50196 +51 2 9.03042 7.20515 11.401 -0.391647 0.322053 -6.58611 +52 1 14.0794 3.58589 8.07965 12.1281 -3.68665 15.0324 +53 2 13.9224 4.24013 7.41233 -5.94016 13.6931 -8.832 +54 2 14.4997 4.05823 8.8235 -7.49262 -7.6028 -6.06268 +55 1 4.66909 17.2524 3.98463 -11.974 -6.63251 3.44703 +56 2 5.54996 17.5659 4.2137 3.76078 6.9996 -9.15965 +57 2 4.29017 17.6906 3.19701 6.52868 -0.394456 6.67531 +58 1 16.4992 16.6027 10.1206 -21.6924 9.71885 22.6747 +59 2 15.7868 16.8403 10.7484 14.9981 -6.02669 -3.77625 +60 2 16.0155 16.0666 9.49209 1.7904 -6.99745 -11.6514 +61 1 1.97502 4.88502 0.412911 -0.608987 3.87721 -1.07962 +62 2 2.72637 5.27959 0.897705 -7.05745 -2.41863 1.64934 +63 2 1.49341 5.65258 18.7073 9.30006 -4.776 -0.647009 +64 1 11.7125 13.3331 16.298 -5.19121 -16.9939 -9.12414 +65 2 11.2215 12.495 16.3147 -7.17559 5.00423 10.7559 +66 2 12.3053 13.159 15.554 3.20757 8.82206 0.62976 +67 1 10.1364 11.0457 16.9267 -8.25027 -0.64471 -2.79768 +68 2 10.5138 10.1546 16.8726 -0.811727 0.343111 1.84422 +69 2 9.16904 10.9405 16.8614 10.4447 -1.98124 -2.23602 +70 1 11.7196 17.4866 13.4532 0.688277 4.88805 11.3616 +71 2 12.4565 17.1915 12.9059 2.31052 0.20251 -3.63622 +72 2 11.8417 18.4468 13.5823 3.75325 -8.25615 -8.02045 +73 1 6.38436 9.31353 12.2227 -10.6166 9.98881 15.1897 +74 2 6.82973 8.96514 11.4526 14.2312 0.227315 -7.303 +75 2 6.92633 10.0292 12.607 -0.115112 -8.7725 -6.80594 +76 1 16.2215 12.7689 2.69197 14.2202 2.36446 -2.70282 +77 2 17.0315 13.2181 2.42332 4.27042 -4.81366 0.268886 +78 2 15.6299 13.4985 2.86911 -16.5638 6.55953 0.86202 +79 1 0.643858 12.5819 5.90471 10.4355 0.0636689 -1.96923 +80 2 0.972356 12.3928 5.01972 -0.601341 2.21783 -2.79245 +81 2 18.3387 12.6591 5.78833 -5.81166 2.35718 1.0682 +82 1 5.2154 16.4273 18.4533 5.05017 -7.28804 7.26993 +83 2 5.85096 15.759 18.1791 -0.38035 -3.88529 -12.2081 +84 2 5.53459 16.6741 0.678671 -3.42073 7.449 3.19712 +85 1 0.551654 7.64481 4.10641 16.2354 21.1246 -10.5626 +86 2 18.6183 7.98546 3.39603 3.07966 -1.83327 6.1622 +87 2 1.42708 8.08449 3.93576 -19.267 -16.5837 1.18512 +88 1 3.12227 8.91534 6.50802 24.2291 -0.585626 7.1452 +89 2 3.7382 8.63748 7.22391 -17.1573 3.17125 -13.7643 +90 2 2.22482 8.81583 6.82729 -5.68465 -1.73896 5.22193 +91 1 7.30086 10.3189 16.2323 -15.6545 -0.122126 6.34207 +92 2 6.59019 10.5178 15.6183 5.33711 0.792532 -4.64 +93 2 6.81196 10.2023 17.0683 9.00195 1.1125 -0.831229 +94 1 11.1139 1.03369 5.01342 4.3303 1.68398 -12.6705 +95 2 11.3068 1.80352 4.46111 -2.07011 7.18197 9.97137 +96 2 10.7762 0.428462 4.34613 -4.44642 -9.51924 3.00218 +97 1 4.39584 2.7383 13.2149 -0.390466 4.89753 -17.2666 +98 2 4.70663 3.24132 13.9776 -1.24631 -10.9908 10.3904 +99 2 4.24133 1.79775 13.4334 4.65854 7.0575 9.14841 +100 1 8.38523 10.0971 1.80824 -1.28714 19.1329 -0.644156 +101 2 8.30354 10.8052 2.48172 0.822207 -7.93375 -7.37013 +102 2 8.79223 9.36658 2.27287 1.71369 -9.23717 4.71722 +103 1 10.4729 1.73916 15.5717 11.6995 -6.53653 -13.4069 +104 2 11.3877 1.45477 15.4183 -5.50109 4.13915 12.9036 +105 2 10.2466 2.11684 14.7151 -9.31794 0.949785 -3.28817 +106 1 2.72932 12.8923 7.77007 2.13638 -2.03638 4.95693 +107 2 3.24355 13.6603 7.47881 -3.48119 -3.6232 -2.9431 +108 2 2.14523 12.6528 7.03806 -2.13852 4.70731 1.87174 +109 1 3.67999 11.6951 5.25129 1.06179 2.30609 -7.65488 +110 2 3.48397 10.8814 5.71277 1.07183 -5.39866 6.20843 +111 2 2.98047 11.7882 4.59744 -0.426908 3.81831 -2.62473 +112 1 6.82829 14.472 16.8976 7.24547 -11.7087 -0.510459 +113 2 7.70535 14.0752 16.845 -3.98439 5.03843 1.85271 +114 2 6.50852 14.4918 15.986 -3.30226 9.38599 0.302494 +115 1 14.1912 14.5549 3.37889 -4.65321 -1.5346 -2.40618 +116 2 13.6567 15.3531 3.27958 4.16996 -0.562804 -5.50008 +117 2 13.6356 13.9417 3.87468 5.16163 -0.564442 6.07906 +118 1 8.32326 18.1549 16.0383 38.0123 0.723105 5.33509 +119 2 8.90126 17.4596 16.3629 -14.277 -18.5473 4.85232 +120 2 9.02384 0.130446 15.7883 -15.867 17.9211 -5.43461 +121 1 4.72767 1.62379 4.93271 -17.6379 -0.985038 1.9521 +122 2 3.81401 1.95679 4.84992 11.4813 -1.52324 3.97162 +123 2 5.23321 2.13073 4.30096 3.99283 5.81443 -10.8958 +124 1 15.0185 12.7583 16.4307 33.5549 -15.7429 -8.88385 +125 2 14.6322 13.2399 17.156 -17.5625 6.9837 5.99474 +126 2 14.4538 12.6352 15.6516 -10.3238 6.55553 8.00439 +127 1 15.7718 18.4254 16.841 -12.0797 -5.1952 -2.21012 +128 2 16.3284 18.515 17.6327 0.946096 -4.9786 -5.09166 +129 2 15.4084 17.517 16.8347 11.7053 8.22526 2.07191 +130 1 1.18057 1.17309 16.5558 11.0398 2.91722 -0.500753 +131 2 1.84524 1.84688 16.7601 6.86303 -5.43895 -3.7977 +132 2 0.618264 1.22767 17.321 -11.8887 1.06625 6.89733 +133 1 18.1125 4.54155 15.913 0.560198 2.18648 6.37111 +134 2 18.4591 4.08913 15.1466 2.75843 -6.08521 -5.17788 +135 2 18.7597 4.4472 16.6204 -1.36812 0.49592 -3.69459 +136 1 12.2402 16.9779 16.1352 2.31512 -6.99762 -15.3414 +137 2 11.5952 16.4515 16.6081 -8.3163 0.999648 8.5775 +138 2 12.0081 16.8315 15.1982 2.22798 9.47321 6.13039 +139 1 15.9623 2.53119 18.0207 2.93621 -4.28086 -0.122131 +140 2 15.5695 3.22825 18.5544 -2.43998 7.63429 -5.2422 +141 2 15.6676 2.68289 17.1026 2.19807 1.36349 7.25858 +142 1 6.70368 13.8359 10.2288 1.24588 -18.109 -1.49583 +143 2 6.57782 13.5214 11.1319 -1.51171 6.96132 4.85856 +144 2 6.68827 13.0063 9.72453 -2.19505 9.55036 -5.72862 +145 1 10.1309 18.2871 2.76796 -14.3596 -6.47533 0.342864 +146 2 10.2029 0.342366 2.11266 2.51428 7.52943 -3.11917 +147 2 9.22516 17.9366 2.63576 15.7336 3.88756 2.50188 +148 1 2.99532 17.7363 6.09725 27.6457 -0.367768 9.57951 +149 2 2.17297 17.7876 5.61616 -10.9588 -3.8104 -13.5012 +150 2 3.724 17.7747 5.44639 -16.7072 2.57282 0.579206 +151 1 12.5761 16.9143 8.00615 -13.9856 15.3012 3.95273 +152 2 11.7456 16.4539 7.8426 4.73348 -10.9119 -5.17088 +153 2 12.3021 17.5765 8.66814 13.2598 -3.61726 -0.932189 +154 1 14.882 15.2803 8.24971 10.681 -0.761738 -5.80123 +155 2 14.3225 16.029 8.07669 -22.8014 8.12514 9.31404 +156 2 15.4227 15.298 7.45407 7.11517 -7.78554 -3.15381 +157 1 17.6329 18.2578 0.365715 -0.853361 22.9802 4.00517 +158 2 18.5235 17.9699 0.161776 5.93848 -16.2402 -3.481 +159 2 17.7627 0.512218 0.708086 -5.13428 -6.58263 -1.39758 +160 1 0.88251 10.4012 1.38524 10.7451 13.2218 -5.20703 +161 2 0.0659506 9.93794 1.52098 -14.8693 -14.1338 10.0664 +162 2 0.630973 11.1288 0.804044 1.28572 5.25949 -2.19783 +163 1 1.64115 12.2217 3.35193 -3.18006 -13.1055 -18.8251 +164 2 1.37082 11.5062 2.75067 2.88651 -5.3868 11.6868 +165 2 1.67765 12.9428 2.72371 4.09986 15.3051 6.03005 +166 1 0.58147 17.2398 4.87485 -10.389 -0.219728 20.623 +167 2 -0.122589 17.8866 4.86961 1.40048 11.6397 -9.93657 +168 2 0.410626 16.8027 5.7206 11.49 -10.3372 -7.14723 +169 1 1.11352 0.964392 9.43077 -4.94184 3.64088 -20.8453 +170 2 1.20387 0.588778 10.3126 -0.847456 -3.79009 5.67247 +171 2 0.226103 0.72639 9.1141 8.25621 -1.04795 9.52173 +172 1 16.7603 2.33922 13.2874 -3.33679 -13.7714 7.5216 +173 2 16.8475 2.59005 12.3669 3.49604 3.27514 -7.50745 +174 2 16.539 1.38388 13.2956 1.74648 12.4468 1.52133 +175 1 2.56382 15.8252 12.169 -1.32309 5.18512 -19.2115 +176 2 3.14843 15.408 12.7949 3.95332 -3.2625 9.96296 +177 2 3.02181 15.7534 11.31 -3.03818 -3.40517 4.91625 +178 1 16.4251 15.6276 5.98753 2.75225 -2.61515 5.58966 +179 2 17.3447 15.6415 6.33695 -10.8386 4.94036 -7.12539 +180 2 16.2312 16.4474 5.48017 12.4296 -10.8984 6.26847 +181 1 5.80144 5.06794 11.7894 5.49032 -3.99323 1.93812 +182 2 5.42192 5.63452 12.4754 -2.65214 7.25607 -4.62846 +183 2 5.38258 4.20716 11.9011 -4.64894 2.39601 -1.00669 +184 1 15.1781 4.86184 0.728524 -4.34825 6.76152 14.6306 +185 2 15.2668 4.67158 1.68153 -8.60174 -1.32446 -9.75027 +186 2 14.3367 5.34751 19.2902 10.4034 -8.61994 -3.37533 +187 1 16.3306 16.3549 2.10387 -3.60874 -8.17165 19.4202 +188 2 16.1436 16.7757 2.96383 0.821724 -8.86269 -6.10473 +189 2 16.4161 17.1032 1.53428 7.22132 12.8567 -17.8694 +190 1 0.267773 4.86229 3.80408 10.7738 -14.2237 3.39069 +191 2 0.48911 5.8014 3.76313 1.80944 1.44211 5.87769 +192 2 1.0394 4.38382 4.18029 -13.1099 14.4171 -4.44332 +193 1 2.95694 15.0447 15.0954 -6.10325 -16.3486 9.96696 +194 2 2.71126 14.628 15.9563 6.59243 11.9398 -10.1751 +195 2 2.48371 15.8886 15.0723 0.827451 0.569437 4.39106 +196 1 1.13642 14.6155 9.54099 -48.9591 -6.29818 10.1377 +197 2 2.0574 14.6763 9.37448 31.1561 -9.052 1.81392 +198 2 0.917533 13.7788 10.0133 17.9146 13.2649 -10.59 +199 1 13.6267 16.618 11.5309 -14.0517 -2.94194 4.54584 +200 2 13.2284 17.3872 11.0909 1.36391 -4.96948 -3.72009 +201 2 13.0435 15.8681 11.2876 10.4622 6.11411 -5.34277 +202 1 4.69594 1.47637 0.748111 -12.1621 -0.739309 -0.414133 +203 2 4.0907 2.00679 0.20438 8.77888 0.173625 -0.66482 +204 2 4.10511 0.858084 1.19895 3.99089 -4.2391 -0.703649 +205 1 1.43799 18.5334 11.8677 4.48354 -19.5441 -2.70285 +206 2 1.28309 0.34807 12.6964 -2.38454 7.77338 6.6957 +207 2 1.65634 17.6099 12.1011 0.514199 12.3996 -0.852918 +208 1 11.5339 10.1172 4.0507 5.82948 9.6286 -18.4863 +209 2 11.2843 10.5321 3.18756 5.15824 -8.38498 16.2271 +210 2 12.5124 10.093 4.04255 -10.5657 0.881913 4.0585 +211 1 8.32129 12.1582 3.72502 1.53352 8.77417 8.44763 +212 2 9.09494 12.6645 4.01218 5.78128 -3.64141 -7.92941 +213 2 7.76311 12.2518 4.50437 -12.3191 -3.17133 -0.801295 +214 1 14.3738 4.02512 3.28302 13.4457 8.56362 13.3606 +215 2 15.0833 4.15474 3.94873 -8.39321 -4.82495 -4.85792 +216 2 13.6328 4.57269 3.59478 1.91801 -3.79011 -4.78214 +217 1 5.59001 1.69403 7.5104 -22.1497 -9.71937 -16.3739 +218 2 4.92965 1.04535 7.86703 17.0022 15.2682 -3.23125 +219 2 5.33019 1.76513 6.54994 10.6546 -4.2597 24.8978 +220 1 17.8762 1.11593 4.87562 6.9502 3.59021 1.61777 +221 2 18.6375 1.36949 4.33979 -2.23157 -1.53514 -7.48501 +222 2 17.9489 1.70322 5.63717 -7.55192 -1.12522 1.72169 +223 1 6.82082 9.41417 4.48467 7.28036 -1.61815 9.25922 +224 2 6.87733 9.61398 5.42883 -5.7945 0.587378 -0.0554941 +225 2 7.74179 9.22243 4.26363 -0.0627487 -3.5933 -6.80471 +226 1 2.67079 14.9403 1.9639 10.8093 -10.5544 22.1131 +227 2 3.25117 14.6591 2.70117 -12.0207 4.93014 -5.95014 +228 2 3.29732 15.1077 1.27121 3.13815 4.27624 -15.5237 +229 1 17.3067 12.913 13.1683 10.6019 -31.6629 4.62367 +230 2 16.4497 13.2737 13.3972 -3.78483 16.2252 -3.80314 +231 2 17.8834 13.5891 12.8053 -8.28955 15.595 1.58636 +232 1 14.9867 10.5664 1.39303 17.3246 -3.28745 6.09509 +233 2 15.5958 11.2392 1.752 -7.58668 -4.78908 -2.0363 +234 2 14.1528 11.003 1.29225 -13.717 8.26159 -1.38466 +235 1 5.69708 6.86241 4.54741 10.2551 2.99419 0.383868 +236 2 6.12873 7.74081 4.58523 -8.39477 -7.3362 -0.690872 +237 2 6.29159 6.23392 4.98874 0.140081 3.89587 3.34658 +238 1 8.04621 8.27418 10.2318 -1.25624 6.00125 -7.48209 +239 2 8.67166 8.94213 9.92965 6.80147 7.39227 7.14523 +240 2 7.62794 8.03247 9.40376 -7.32264 -11.607 2.12748 +241 1 13.4746 18.3625 5.78211 -13.502 7.51331 -2.26288 +242 2 12.7551 0.364455 5.61988 6.67968 -8.24018 -2.37745 +243 2 13.1168 17.8207 6.50434 6.50164 -0.829271 0.111391 +244 1 0.226362 2.58719 0.131375 -15.5932 24.0028 11.6326 +245 2 17.9693 2.93929 18.6394 3.5786 -16.3529 -5.12341 +246 2 0.708035 3.3711 0.44675 7.58398 -8.21165 -4.7522 +247 1 12.703 11.0237 9.75181 24.9284 -7.65781 8.94422 +248 2 11.7937 10.9936 9.46616 -11.7502 -8.38149 -1.23796 +249 2 12.9608 10.1029 9.99094 -10.5021 9.57622 -2.72207 +250 1 0.761974 12.2205 11.0816 -4.15363 -6.09516 -21.355 +251 2 18.4366 12.288 11.0674 3.38909 -0.754442 8.49561 +252 2 1.11175 12.4338 11.9478 -3.68194 5.91832 8.04416 +253 1 5.07253 7.26896 13.4467 3.90397 -0.0234352 3.77117 +254 2 5.61152 7.96046 13.0436 -1.11485 3.21213 -6.58832 +255 2 5.53238 7.13074 14.2827 -1.05457 -4.33313 3.81413 +256 1 1.23629 6.9109 11.8337 28.2892 12.95 23.6673 +257 2 0.51347 7.34016 11.3984 -13.736 7.24235 -8.87687 +258 2 1.75935 7.64669 12.2495 -13.9201 -17.9067 -15.9983 +259 1 15.4873 9.53008 12.3182 -0.383493 4.12812 -8.89679 +260 2 15.0655 10.399 12.2152 3.51435 -2.6855 7.45914 +261 2 15.2649 9.14784 13.1724 -1.90612 6.52608 2.19385 +262 1 16.6085 12.8345 5.46896 -3.55761 11.1023 -1.95777 +263 2 16.4419 13.7896 5.48874 0.313493 -0.193839 12.6146 +264 2 16.4475 12.6632 4.54137 -0.0496347 -14.7353 -8.15109 +265 1 6.20534 9.98194 0.0899104 18.0768 -8.37359 0.258846 +266 2 5.59572 10.4068 0.70246 -2.59094 3.74961 3.89273 +267 2 7.08249 9.9872 0.527613 -14.0474 2.02387 3.58276 +268 1 12.3397 6.07843 4.05984 1.81271 11.939 -8.21694 +269 2 12.2328 6.8085 3.41842 8.48996 -4.45606 3.14495 +270 2 11.4615 5.7138 4.10837 -10.8447 -6.35959 3.05037 +271 1 0.186481 12.7968 0.194157 8.45417 -0.362633 0.823389 +272 2 0.122538 13.4857 0.868002 -3.08717 1.48078 1.57348 +273 2 18.4164 13.184 18.057 -2.66731 -2.48236 -4.34426 +274 1 3.77162 18.5917 8.57827 -20.4554 1.45559 2.68175 +275 2 3.52322 17.9715 7.87805 6.33007 3.25639 -1.82086 +276 2 2.90938 0.367014 8.76804 7.74592 -0.0744794 5.639 +277 1 7.46409 17.2961 4.48316 -14.1198 -17.2275 8.02552 +278 2 7.88946 18.1398 4.59819 4.06261 16.9953 -5.43573 +279 2 7.32948 17.1504 3.54137 6.62361 8.1702 -3.03871 +280 1 9.24056 17.0796 12.2607 -1.29913 -0.841935 -6.42698 +281 2 9.19718 16.4258 11.5387 7.57092 0.344645 9.78983 +282 2 10.1052 16.9888 12.7016 -6.07497 2.05659 -6.06408 +283 1 13.326 12.928 7.96212 4.69357 25.6567 2.07593 +284 2 13.3763 12.2768 8.65803 -4.91574 -13.7878 2.50151 +285 2 13.7353 13.7181 8.35204 8.56042 -2.58857 -8.38859 +286 1 14.9538 2.97298 15.3382 -4.29462 -11.8182 -2.96981 +287 2 14.4639 2.15222 15.1644 -2.78402 11.1896 3.17375 +288 2 15.6292 2.97829 14.6488 1.75 3.70602 0.0805282 +289 1 9.85487 15.5414 16.9955 1.72232 -1.82893 -0.169847 +290 2 10.3837 14.7676 16.7382 -3.42626 -0.271454 1.71497 +291 2 9.29261 15.2923 17.7497 4.44449 2.55726 -1.27949 +292 1 11.3089 8.30526 16.5494 -6.04997 -6.2326 7.21044 +293 2 10.5881 7.89563 16.0543 2.01853 1.78394 -3.12513 +294 2 11.4835 7.65722 17.2517 2.74023 7.81545 -1.84368 +295 1 3.836 18.1836 16.7517 -7.13385 -19.1452 -23.0441 +296 2 4.27407 17.4593 17.223 1.84106 9.67264 7.83483 +297 2 3.88222 0.348533 17.2402 4.94653 11.64 14.7969 +298 1 2.18178 4.13609 8.93005 8.1701 -0.774865 9.73019 +299 2 3.0913 3.90524 8.75773 5.46766 -1.37508 -11.1104 +300 2 2.14869 4.01328 9.88774 -11.2166 4.12208 2.959 +301 1 9.87742 10.3647 9.70242 2.63105 14.1486 10.9213 +302 2 9.56679 11.2208 9.35298 -0.359428 -9.80694 -0.658425 +303 2 10.1334 10.5423 10.6269 -4.00587 -8.10964 -6.10976 +304 1 9.70429 0.823826 10.8553 -14.0108 4.16215 1.0267 +305 2 9.1278 18.77 11.1938 11.0832 -7.32823 7.11532 +306 2 9.14207 1.22722 10.1856 4.51331 8.02138 -6.87563 +307 1 9.20617 15.1402 10.2178 -11.609 -5.72992 -0.101326 +308 2 8.7465 15.767 9.6415 2.03963 4.50002 1.17892 +309 2 8.51696 14.4821 10.4282 6.2553 7.07807 -5.66984 +310 1 0.996164 9.40777 10.3157 -31.4617 35.4735 1.80375 +311 2 1.02993 10.3821 10.3914 -11.0752 -10.4846 4.01107 +312 2 1.89609 9.22017 10.2201 37.6387 -20.6805 -6.1303 +313 1 16.8786 4.85128 8.17759 -11.2506 16.3288 -5.48708 +314 2 16.2388 5.56314 8.38188 8.44756 -9.04525 0.78656 +315 2 16.9626 4.34108 8.98054 4.36808 -7.38136 2.74573 +316 1 14.6815 14.711 0.319263 14.4838 0.937126 -3.06264 +317 2 15.2721 14.9301 1.06391 -7.87321 4.75235 -6.44468 +318 2 13.8763 14.3724 0.714255 -5.91657 -4.41648 2.02008 +319 1 3.57415 11.0448 9.58418 2.91679 3.40936 2.58946 +320 2 3.69173 11.5263 10.4228 -3.34733 -6.02301 -1.37626 +321 2 3.07399 11.6483 9.00652 3.80152 0.245021 0.575116 +322 1 11.1013 10.8086 1.33492 -13.1151 -1.75228 0.351043 +323 2 11.4484 11.639 0.990604 2.68761 3.85867 -0.677593 +324 2 10.1644 10.7789 1.04773 13.6271 -2.80152 6.25142 +325 1 13.1828 7.11823 12.837 13.875 6.93007 -2.08809 +326 2 14.1546 7.00576 12.8731 -8.73741 -0.33434 -1.11439 +327 2 12.8407 6.21951 12.8306 -5.12621 -6.60309 0.0889066 +328 1 9.62491 1.88499 0.973614 -3.42399 -6.06492 -12.2684 +329 2 8.82152 1.4846 0.597998 2.34171 8.22807 3.07369 +330 2 10.1781 2.12743 0.21359 -0.384483 0.556473 6.61436 +331 1 10.6031 13.5334 4.66686 13.636 -3.8461 -1.22567 +332 2 11.4763 13.1252 4.55872 -4.58351 -5.15517 0.0143246 +333 2 10.7077 13.9241 5.53959 -7.66657 9.10334 4.04553 +334 1 14.3485 1.75735 10.9256 -1.10429 -17.7549 1.09656 +335 2 15.1861 1.44338 10.54 -2.80824 6.90847 2.1648 +336 2 14.3834 2.71874 10.9625 8.08978 3.11888 -5.0019 +337 1 14.6333 12.3432 11.6996 -1.39952 -9.16637 -24.1357 +338 2 15.3681 12.4502 11.0746 9.0546 4.11007 14.4837 +339 2 13.9355 12.122 11.0753 -11.0061 -2.1546 9.49113 +340 1 8.24004 5.06512 9.81661 -6.73852 -15.0928 -6.1646 +341 2 7.43321 5.24609 10.2868 -7.68507 10.8263 10.6715 +342 2 8.07004 4.14881 9.53169 13.9201 5.19095 -3.88371 +343 1 1.57861 16.855 18.3455 -3.6047 -18.8696 23.6299 +344 2 1.81992 17.2862 17.5419 10.6717 7.49965 -18.3027 +345 2 1.88846 15.9289 18.2434 -7.51751 10.9825 -1.36554 +346 1 1.48469 17.2399 15.3369 -30.5992 8.85894 1.58219 +347 2 1.52903 18.0991 15.7763 5.64601 2.15314 -3.36931 +348 2 0.515015 17.0623 15.2815 21.6878 -4.25813 -0.913042 +349 1 3.6961 5.66103 6.13276 1.27154 -4.68408 -0.174538 +350 2 3.02861 6.15393 6.634 5.94065 6.05513 -0.564102 +351 2 4.2706 6.29315 5.66099 -8.13711 -1.6893 2.05746 +352 1 12.3863 9.46112 14.1898 5.64676 -22.9439 1.72589 +353 2 12.6155 8.61212 13.7476 3.53191 14.2422 4.21489 +354 2 12.2183 9.16782 15.1036 -0.67103 6.17556 -4.58111 +355 1 4.03262 15.2884 6.88962 -6.96122 -2.16466 3.53978 +356 2 3.61008 16.076 6.4989 3.67472 -5.21865 6.04109 +357 2 4.98914 15.3892 6.82497 3.29203 7.08348 -5.36605 +358 1 0.610585 8.57451 14.9167 2.06858 8.16468 9.66942 +359 2 0.571526 9.5334 15.101 -0.509723 -6.74541 -4.80249 +360 2 1.24768 8.49017 14.2004 3.24343 3.39805 -1.00154 +361 1 12.9947 8.30502 10.3347 -2.10898 5.96297 -3.02925 +362 2 13.7245 7.79451 9.98073 4.34503 -3.62623 -11.9067 +363 2 13.0194 8.04092 11.2546 -7.35013 -0.655157 9.61409 +364 1 15.3021 7.68636 3.53463 20.0464 32.042 -6.64886 +365 2 14.6007 7.2355 3.06802 -7.18972 -17.1123 8.01585 +366 2 15.7144 7.29713 4.32433 -16.1768 -11.7678 -0.766084 +367 1 17.3034 6.68003 0.0493874 -1.84179 -13.5509 -2.88881 +368 2 16.9519 5.78424 0.161568 0.711034 6.10552 3.25575 +369 2 16.5083 7.2036 18.5276 -0.473138 7.46776 -7.84911 +370 1 8.84315 6.93181 7.84628 -0.943806 11.0529 -13.3888 +371 2 9.77771 7.20927 7.80441 -6.03996 -2.82935 4.46193 +372 2 8.74315 6.27043 8.54219 4.24547 -3.80386 5.92931 +373 1 12.3578 0.616451 1.20223 7.02437 -6.39463 -1.478 +374 2 13.2861 0.535705 1.47006 -5.02329 6.70293 3.96338 +375 2 12.2631 18.6802 0.444477 -1.70715 1.25222 -1.43865 +376 1 5.64724 15.135 14.5406 -0.604856 -11.7009 0.79572 +377 2 4.70142 15.1669 14.7844 5.92695 5.15448 -4.69419 +378 2 5.94602 16.0188 14.2721 -2.36621 0.047849 -2.09121 +379 1 3.86203 6.47491 1.73695 1.36817 -0.22553 5.39386 +380 2 3.46749 7.3178 1.48065 -2.80916 3.79134 -8.60259 +381 2 4.09027 6.61791 2.66801 -1.52617 -4.74348 -3.78665 +382 1 3.89615 11.6258 12.3135 -4.96985 -7.23752 -2.42851 +383 2 4.76636 11.9561 12.5635 2.33504 5.86151 0.242199 +384 2 3.23901 12.1927 12.7515 8.69891 -3.88643 -0.482475 +385 1 5.40213 3.8611 15.8693 10.8945 -12.2769 2.09816 +386 2 6.15363 3.21949 15.8699 -18.4435 12.0745 -5.1575 +387 2 5.79254 4.73962 15.8533 3.23601 3.32406 0.742539 +388 1 14.4255 10.2871 4.42158 -5.00773 -17.9107 13.5675 +389 2 14.5181 9.70279 5.20492 2.69814 10.8256 -8.91808 +390 2 14.7837 9.77905 3.68069 -0.206993 2.85241 0.289205 +391 1 7.87167 17.3723 9.20121 -10.8695 6.25183 -3.73994 +392 2 7.03582 17.6433 9.5986 1.28641 -7.15132 6.24862 +393 2 7.9635 17.9776 8.45108 8.3983 -5.79413 -1.77097 +394 1 4.52981 14.473 3.9851 -7.27149 14.4717 16.1092 +395 2 4.4292 15.3844 4.34508 5.86047 -13.4028 -12.5476 +396 2 4.51094 13.8931 4.76638 0.622359 -0.721789 -7.97238 +397 1 14.2548 7.40188 15.768 -9.88191 3.80355 1.83721 +398 2 15.2055 7.32768 15.6782 10.3356 -1.93634 -2.70959 +399 2 14.1214 7.72007 16.6658 2.42251 2.42868 0.921806 +400 1 2.92318 18.2319 1.90056 8.21916 -2.84793 -3.01579 +401 2 2.38261 17.6158 1.3774 3.82694 3.92633 -2.29165 +402 2 2.32657 18.895 2.2462 -10.4983 4.84254 7.82145 +403 1 7.9872 1.59624 4.55123 -13.2342 7.82044 -5.09514 +404 2 7.38456 2.15817 4.04087 -4.12207 -9.74777 1.09289 +405 2 8.829 1.94177 4.28864 19.9647 -0.586446 1.64736 +406 1 2.52886 14.1331 17.7106 9.56011 -8.28606 7.0204 +407 2 2.01365 13.3855 18.0679 -1.20108 10.5585 -3.23507 +408 2 3.45026 13.9294 17.9721 -7.58546 -2.42865 -2.00823 +409 1 0.784808 1.71729 13.877 -22.3729 3.14932 11.7627 +410 2 0.820241 1.39718 14.7912 6.0833 4.21121 -6.47959 +411 2 18.4913 1.99435 13.7832 17.5446 -4.15928 -6.69512 +412 1 4.49906 18.6473 13.9354 -18.7945 1.8826 8.61585 +413 2 5.41644 18.4141 14.0419 11.9469 -5.27484 -6.26214 +414 2 4.07897 18.3597 14.7657 2.79866 5.45516 -5.58976 +415 1 7.09283 0.599142 18.3486 34.6471 -4.12786 -6.63011 +416 2 7.39021 0.234617 17.4878 -9.84259 3.28252 9.67216 +417 2 6.14438 0.553251 18.3894 -16.3447 5.16139 0.014819 +418 1 16.0881 18.4309 14.0453 5.06229 7.716 24.0321 +419 2 15.2482 18.0804 13.8032 -16.2536 -8.6858 -12.6141 +420 2 15.9952 18.587 15.0073 9.58514 -0.127307 -10.5143 +421 1 10.0776 4.50678 16.2676 12.8821 37.0646 3.31891 +422 2 10.9819 4.89306 16.3611 -10.6263 -20.5161 -3.34059 +423 2 10.1424 3.55939 16.3223 6.24363 -16.5382 -1.58612 +424 1 15.8992 17.8398 4.41934 12.2004 7.51097 -4.98004 +425 2 16.3832 18.6941 4.42415 -3.71288 -10.9395 3.02327 +426 2 14.9903 18.0494 4.62819 -9.96916 6.21932 6.5896 +427 1 6.98832 17.3871 13.7576 13.6855 5.49553 14.8404 +428 2 7.37965 17.5993 14.631 -4.71479 -0.449691 -14.3122 +429 2 7.76575 17.2997 13.1656 -13.1106 -1.1113 5.84114 +430 1 13.2824 6.5097 6.67953 4.56939 11.9611 -5.54075 +431 2 14.0532 7.04843 6.47095 5.72005 -2.26771 11.4806 +432 2 12.9258 6.37058 5.8058 -10.6331 -8.36185 -8.97535 +433 1 7.75109 2.3756 9.23631 -5.33505 -3.40336 15.3372 +434 2 7.18759 2.24157 10.0186 8.87424 2.78019 0.355864 +435 2 7.20141 2.0575 8.52046 -4.61968 -0.366971 -12.063 +436 1 15.1734 14.8403 13.6669 0.441467 -1.73197 5.96822 +437 2 15.0738 15.2212 14.5455 0.591215 -4.0348 4.14746 +438 2 14.518 15.2716 13.122 -1.09719 2.73458 -8.10719 +439 1 9.35119 8.31644 3.739 2.66762 7.66889 5.69365 +440 2 10.15 8.71947 4.13947 -5.98752 -7.29531 -6.80605 +441 2 9.38201 7.35632 3.87197 4.69073 2.10751 1.74529 +442 1 17.751 13.5231 16.4139 1.76506 1.52762 0.696064 +443 2 16.8205 13.2419 16.3833 1.32585 7.25436 -2.93419 +444 2 17.8025 14.3962 15.9827 -4.54797 -4.37418 0.927992 +445 1 4.99908 10.6417 2.69781 -10.2301 11.821 9.59097 +446 2 5.61637 10.2237 3.29708 11.0389 -6.03173 2.08237 +447 2 4.70065 11.4181 3.20566 0.509198 -9.80178 -10.0294 +448 1 3.73671 8.33589 10.2301 0.811909 12.56 -11.1256 +449 2 3.79833 9.26935 9.95307 1.30999 -3.93497 -1.66187 +450 2 3.73931 8.38186 11.1831 0.045476 -4.76093 8.99044 +451 1 16.0469 7.05349 6.21752 -8.36922 7.98368 -7.54927 +452 2 16.8656 7.47651 6.4961 3.44749 0.07849 4.67395 +453 2 16.1438 6.1088 6.32704 6.52122 -4.4821 -3.05144 +454 1 15.1289 7.04368 9.08785 10.4694 9.8467 1.75835 +455 2 15.8264 7.38614 9.67453 -3.18259 -3.19274 -6.50653 +456 2 15.1274 7.66298 8.34243 -1.48772 -3.73631 0.00250057 +457 1 6.37899 13.0555 12.8241 7.15095 -9.93714 4.62427 +458 2 7.14263 12.6042 13.2293 -5.49135 0.351509 -10.6671 +459 2 6.23455 13.8287 13.3737 -7.10156 7.81238 6.40695 +460 1 12.1361 4.49173 13.0886 -33.3605 -9.49617 -7.12831 +461 2 12.0495 4.6518 14.0281 12.9755 3.95225 11.8447 +462 2 11.274 4.06082 12.879 23.5373 6.19102 -2.9945 +463 1 11.3516 8.18262 7.87035 -14.4325 7.02786 -3.11936 +464 2 12.0471 7.65769 7.46008 8.6713 -7.43794 3.47117 +465 2 11.5359 8.26397 8.81258 10.0684 -2.50636 2.15934 +466 1 17.1915 10.8124 7.44959 -16.1176 10.6393 13.8832 +467 2 17.9047 10.1798 7.28217 -0.931293 1.13858 -10.0543 +468 2 16.9855 11.3827 6.68215 10.1883 -6.89581 1.62445 +469 1 5.25104 18.1119 11.0466 -2.03712 6.82198 -5.53245 +470 2 4.55844 17.9395 11.7023 5.22213 1.54215 -0.259713 +471 2 4.79647 18.4173 10.2467 -3.05137 -7.80568 1.06144 +472 1 7.59144 17.5428 1.82585 2.02366 6.3387 -27.4892 +473 2 7.8094 16.7742 1.27336 1.17923 0.135637 10.7354 +474 2 7.55288 18.254 1.15356 -7.65387 -5.36774 12.2151 +475 1 1.92063 12.9184 13.6023 -9.91855 -8.75107 -5.23832 +476 2 1.37345 12.2779 14.0844 5.59931 4.65398 4.03533 +477 2 2.08932 13.6638 14.189 3.88592 4.92281 2.07481 +478 1 9.68002 6.79239 14.8375 -5.9785 1.55821 1.53848 +479 2 9.8605 5.87105 15.0454 -1.79232 -6.14635 7.43903 +480 2 10.0701 6.92553 13.9753 -0.129146 4.69231 -11.1498 +481 1 15.2463 4.32976 10.758 3.34542 15.1712 12.775 +482 2 16.1952 4.27653 10.855 10.1577 -17.3864 -7.84826 +483 2 15.0718 4.96713 11.4544 -13.5892 3.80238 -1.28771 +484 1 11.2223 6.14234 0.184515 14.935 15.986 0.702496 +485 2 11.3427 5.2537 -0.179589 -9.34658 -3.11564 3.17557 +486 2 10.3073 6.45674 18.8196 -5.33379 -13.1911 -7.29958 +487 1 0.101128 11.3538 15.0994 -20.5112 19.1646 -16.3994 +488 2 18.0631 11.5965 14.4157 17.8209 -6.40715 11.0417 +489 2 18.7281 12.1498 15.6639 -2.69532 -11.5931 2.167 +490 1 7.07341 9.21118 7.26397 13.6545 -4.38359 1.14819 +491 2 6.46912 8.52168 7.54812 -6.91606 -6.22713 3.38737 +492 2 7.94495 8.78194 7.35853 -7.81842 8.24868 -3.32543 +493 1 18.379 15.4045 12.3485 -3.73833 -6.55761 4.14497 +494 2 0.693581 15.4288 12.2501 6.70794 3.85833 -5.56408 +495 2 17.998 15.8269 11.5664 0.97425 0.444703 -1.66759 +496 1 16.5516 4.36462 5.23826 -5.38189 5.67955 -17.8631 +497 2 16.655 4.28498 6.19256 13.2509 -4.37544 3.08954 +498 2 17.3965 4.59413 4.7818 -8.47419 -6.89051 15.5314 +499 1 17.7443 3.09877 10.7286 3.04827 -10.7181 -6.87848 +500 2 0.0283995 3.26624 10.9392 2.02267 5.05617 3.97045 +501 2 17.7464 2.2027 10.3321 -6.96828 10.7891 3.50943 +502 1 12.2779 0.0212452 10.1338 -0.475788 -3.12763 3.03365 +503 2 11.45 0.377358 10.5143 6.17492 -0.459139 -6.32122 +504 2 12.9469 0.721114 10.1609 -4.48032 5.31969 3.75096 +505 1 10.3747 9.79435 12.3975 0.995366 2.64477 2.84838 +506 2 11.0916 9.86004 13.0462 0.88472 -0.940912 -1.26785 +507 2 10.2331 8.84374 12.2815 -0.892889 0.226532 -0.81052 +508 1 0.549483 2.84316 7.02126 -1.47246 -21.9217 -16.5589 +509 2 0.577314 3.5439 7.66737 3.67317 4.63089 12.4819 +510 2 0.765862 2.00117 7.45653 1.04632 13.6877 4.9994 +511 1 0.405258 15.2829 6.93023 -2.49907 -5.43649 4.98244 +512 2 0.538371 14.8975 7.8327 2.16571 9.44122 -16.3162 +513 2 0.725684 14.6278 6.28848 -1.93707 -3.30699 10.9749 +514 1 17.0129 7.01771 15.2646 8.6122 -7.5627 -5.22629 +515 2 17.8138 7.53109 15.1273 -3.20292 15.4854 -2.58719 +516 2 17.4051 6.15342 15.4314 -10.2841 -6.73634 6.86556 +517 1 9.05466 12.4444 8.11302 13.0521 -10.4864 -20.5516 +518 2 9.3276 11.8473 7.39447 15.1337 1.48797 7.8591 +519 2 8.12011 12.397 7.99286 -24.7878 10.4099 9.23055 +520 1 1.26093 1.88381 3.01396 9.71768 11.5305 -0.318626 +521 2 0.781341 2.25664 2.27301 -4.68813 -2.91629 -4.97973 +522 2 1.78505 2.63319 3.35529 -3.04295 -14.2735 3.58948 +523 1 4.11799 15.1078 9.73252 4.576 2.76804 -1.92408 +524 2 4.09335 15.377 8.80945 -5.53143 0.588802 -2.3225 +525 2 5.02333 14.7824 9.83323 -1.70794 -2.53339 7.76874 +526 1 7.21252 2.18262 14.5895 -3.17269 -14.8219 8.52343 +527 2 7.02371 1.74902 13.748 4.05246 3.09826 3.19753 +528 2 7.71073 2.97164 14.4061 4.58862 11.2949 -7.92291 +529 1 18.5773 14.6793 2.1781 -14.8885 -13.9434 -3.10254 +530 2 0.806981 15.0773 2.13409 4.68638 9.16713 1.06255 +531 2 17.8879 15.3584 2.08187 6.00104 3.32119 3.09374 +532 1 9.95988 2.75708 12.9307 -3.19888 4.8993 -0.068744 +533 2 9.83509 2.14797 12.1955 3.80206 -8.82317 -3.94881 +534 2 9.20326 3.3528 12.8696 -1.08171 3.11286 5.06453 +535 1 2.85334 8.94069 13.0534 -9.07349 -10.7547 -1.24525 +536 2 3.30632 9.75091 12.8027 2.98523 12.1914 -0.768468 +537 2 3.53212 8.32042 13.3313 9.61222 -2.32206 4.81477 +538 1 3.22451 8.40753 3.67121 22.1548 25.1655 0.793749 +539 2 3.78763 9.07745 3.2153 -17.2399 -11.2925 0.757254 +540 2 3.40605 8.58793 4.60238 -4.67213 -6.04062 1.9181 +541 1 5.62069 7.18926 8.53747 6.69229 -2.05947 9.74796 +542 2 5.86853 6.28591 8.76536 -0.744086 -3.6627 -12.9201 +543 2 5.09246 7.43537 9.3012 -7.69944 9.66912 -1.05292 +544 1 14.8771 1.33506 1.99369 -4.37531 -14.3045 14.6387 +545 2 14.6174 2.14132 2.47402 3.99094 2.69357 -12.1219 +546 2 15.1274 1.48157 1.08098 3.94771 15.4277 -5.2716 +547 1 8.29964 15.2018 0.824762 -0.280237 2.12341 -18.5848 +548 2 9.0741 15.0554 1.38374 0.657448 -4.01578 8.69554 +549 2 7.56069 14.656 1.13255 5.04945 -5.16558 7.75703 +550 1 15.6052 1.34643 7.22407 3.75056 4.73875 0.699016 +551 2 15.0587 0.773182 6.67423 -5.35564 1.12746 0.995868 +552 2 15.1053 2.16848 7.37587 -1.8024 -6.33902 1.47434 +553 1 4.99443 13.0609 18.5093 -5.69789 -0.343563 -13.2097 +554 2 5.39232 13.2306 0.720212 5.08054 -1.92613 6.3414 +555 2 5.7137 13.1567 17.8693 -5.50653 4.49423 4.11534 +556 1 15.3782 8.49607 18.1492 -5.08872 -0.806473 3.30258 +557 2 15.7135 9.0139 17.4023 0.0404722 4.09908 2.1153 +558 2 15.1698 9.14329 0.203973 4.81283 -1.94937 -4.21801 +559 1 12.0917 3.05456 18.3485 5.25344 -19.9367 5.19329 +560 2 12.3328 2.56101 0.492796 -7.10973 11.5886 11.7441 +561 2 12.4167 2.41374 17.7115 -1.86526 8.77132 -18.5664 +562 1 13.1991 12.6728 5.17615 -0.124316 -0.0560055 4.18836 +563 2 13.6438 11.8331 5.03438 2.42254 -3.05364 -13.3032 +564 2 13.4089 12.8359 6.10375 -5.84435 4.2533 1.84347 +565 1 6.03469 7.1207 0.0631469 12.4635 -7.18562 -1.52206 +566 2 5.88549 8.01359 19.0305 -4.09863 7.65543 -4.79966 +567 2 5.21365 6.64029 0.190066 -5.29753 1.61074 5.21091 +568 1 17.6997 15.9613 14.987 30.7149 -12.4194 32.4504 +569 2 16.8862 16.4214 15.1458 -18.1669 6.52853 -13.961 +570 2 17.8877 15.7083 14.0822 -14.2113 6.66636 -19.3843 +571 1 13.1806 0.977208 16.5993 3.21446 -7.78263 -3.05852 +572 2 14.1069 0.725878 16.7441 -1.84519 3.55213 2.46319 +573 2 12.7536 0.148831 16.339 0.610986 0.436683 6.04854 +574 1 11.0624 14.5912 7.28204 -11.2181 -3.76258 -2.73638 +575 2 10.3867 13.9846 7.62705 2.11873 3.9908 3.08505 +576 2 11.9143 14.2091 7.50586 0.261112 -7.43153 0.664812 +577 1 17.506 8.58052 2.09005 -0.444247 -11.7988 -12.468 +578 2 16.6642 8.31502 2.4773 -2.50704 5.84538 6.9832 +579 2 17.563 7.99026 1.31874 6.86903 3.37396 8.78538 +580 1 12.3502 7.95652 1.98027 -3.36099 -5.49894 -2.13311 +581 2 11.9195 8.80992 1.98547 0.506131 9.65618 1.3531 +582 2 11.9377 7.50693 1.23044 6.6222 -7.49408 4.60604 +583 1 11.9327 14.6311 10.3511 -13.8226 21.3891 7.58711 +584 2 12.0851 13.8189 9.91206 10.3006 -23.5502 -10.4516 +585 2 11.0014 14.8158 10.1424 3.95037 3.15478 8.54077 +586 1 6.86541 7.01247 15.582 10.3214 -0.24422 -5.9518 +587 2 7.78025 7.06796 15.2658 -3.95377 -6.01896 -2.62563 +588 2 6.83046 7.729 16.2102 -7.67029 5.21932 8.6005 +589 1 8.00165 4.68416 13.4443 -21.8863 -22.7248 -23.0503 +590 2 7.36443 4.84116 12.7101 7.64348 -4.39085 15.7408 +591 2 8.44337 5.50298 13.5544 13.6077 24.8283 3.95349 +592 1 13.4082 12.1692 14.291 7.74384 0.583631 -6.74495 +593 2 13.3391 11.2097 14.1788 -8.03609 -0.555633 4.00216 +594 2 13.8852 12.4587 13.496 -2.17037 2.06617 1.19415 +595 1 14.784 9.43826 7.28323 -11.1269 12.8929 16.9671 +596 2 15.4951 10.0466 7.55684 1.33033 -10.8665 -8.82607 +597 2 14.017 9.71262 7.81429 7.01149 -4.68319 -9.50468 +598 1 12.6837 17.0142 3.10751 10.9269 -13.9095 9.51878 +599 2 12.9708 17.2813 3.99359 -6.48615 4.53386 -3.20168 +600 2 12.1282 17.7068 2.75827 -7.19321 10.5694 -1.73823 +601 1 1.13983 7.14905 17.429 -19.8537 -0.642492 -7.24746 +602 2 0.229092 6.89189 17.6928 9.24629 12.0374 -0.554306 +603 2 1.04788 7.63326 16.5858 1.73105 -6.23108 5.83737 +604 1 12.8283 5.10796 15.6891 -3.1105 -1.51238 -5.72518 +605 2 13.5351 4.46064 15.5231 -0.330328 2.49365 6.49287 +606 2 13.2544 5.98171 15.6287 1.13166 -7.6156 1.26811 +607 1 2.48175 3.38612 5.07416 -11.4746 -6.3359 16.597 +608 2 1.87059 3.13723 5.824 15.2627 10.0051 -19.3068 +609 2 3.07561 4.08306 5.41325 -9.83136 -1.83582 -2.79497 +610 1 8.32062 11.2204 13.4908 14.3326 -12.3724 2.23055 +611 2 8.41586 10.9603 14.3918 -15.5351 3.38632 26.9235 +612 2 9.1195 10.7822 13.1796 -2.73354 4.12568 -26.6086 +613 1 12.9112 1.40899 13.3219 3.38587 -22.7152 11.6955 +614 2 13.5257 1.21801 12.5994 -2.66679 10.6744 -3.40434 +615 2 12.4724 2.23119 13.1327 -1.22779 13.5514 -6.35015 +616 1 6.39925 13.6301 2.14388 13.7527 -0.778699 -6.56015 +617 2 5.84347 14.0897 2.78318 -1.88549 -3.79567 9.96763 +618 2 7.03431 13.0755 2.63977 -7.58465 4.89894 -0.0461429 +619 1 15.9327 6.56061 12.7538 -0.9836 2.19135 -10.6596 +620 2 16.5146 6.98287 12.103 -5.34808 0.40017 1.48081 +621 2 16.2873 6.8165 13.6112 3.99792 -3.90075 7.11277 +622 1 16.8306 0.705066 9.59578 -7.6122 -1.79623 -7.44488 +623 2 16.785 18.3903 9.75048 3.18156 2.06447 -0.865929 +624 2 16.3719 0.843651 8.74144 5.4764 0.262409 5.10626 +625 1 6.12658 11.6826 8.3633 -3.5227 -13.2845 -7.84739 +626 2 5.19255 11.5559 8.64231 15.2704 -3.4985 -2.63712 +627 2 6.45331 10.8168 8.01189 -8.18375 16.1965 9.35276 +628 1 2.85137 8.68091 0.385463 -5.58051 9.89965 12.0536 +629 2 2.19225 8.31695 18.4611 -2.16592 -25.8024 -20.6889 +630 2 2.2971 9.35613 0.77772 10.4924 10.4953 14.3564 +631 1 10.1291 10.4583 6.52809 -2.44089 1.08082 5.72444 +632 2 10.551 9.78353 7.0828 -0.111445 0.581803 -4.14441 +633 2 10.6952 10.5682 5.75546 0.540532 -2.90301 -3.90698 +634 1 6.75412 15.726 6.57209 -8.13971 -2.30487 -2.02419 +635 2 7.24364 15.9641 7.36655 2.15693 7.18823 -0.87292 +636 2 6.8879 16.4298 5.90744 8.86888 -7.67267 7.00242 +637 1 6.43944 13.0908 5.62507 5.5957 4.80241 6.78236 +638 2 6.68766 13.9873 5.91055 -1.86537 -6.12454 -2.89892 +639 2 6.02344 12.6885 6.39583 0.545895 -2.8305 -0.33431 +640 1 16.7919 12.5477 9.81186 8.33998 7.78307 -15.4118 +641 2 16.959 11.947 9.07064 -2.3739 -7.40637 3.16023 +642 2 17.0566 13.4004 9.43565 -5.48117 -2.43007 10.0621 +643 1 6.08508 2.94496 2.79534 5.32525 -4.78467 20.7365 +644 2 6.22401 3.88181 2.60268 1.06349 -0.160394 -8.38338 +645 2 5.80007 2.47136 2.00522 -4.08992 3.93243 -8.80646 +646 1 10.8869 3.24711 3.28239 -4.40001 1.54122 -3.81905 +647 2 10.3919 4.04182 3.50512 -0.182415 -1.04618 4.274 +648 2 10.507 2.97693 2.43998 1.37333 -6.80979 -0.861155 +ITEM: TIMESTEP +40 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.77679 7.00681 17.9176 19.5781 -11.4355 -6.13067 +2 2 7.88289 7.04978 18.2154 -24.3238 4.20085 7.9494 +3 2 8.82569 6.20257 17.3924 1.80136 1.41546 -3.93969 +4 1 18.6608 8.28849 6.81179 -5.26854 6.47195 -37.0065 +5 2 0.259818 8.10211 5.87223 -9.20216 6.37217 14.1473 +6 2 0.533966 7.65898 7.28863 11.4703 -14.4857 21.9358 +7 1 8.44459 18.6539 6.84319 -15.0888 3.44445 3.75329 +8 2 9.31627 0.207433 6.52222 15.1831 4.47029 -4.67038 +9 2 7.87035 0.688968 6.45696 3.7806 -3.44044 1.26969 +10 1 6.57294 1.78151 11.6706 -30.0599 9.45416 18.0529 +11 2 5.79693 2.24632 12.0928 24.7239 -13.8096 -10.3139 +12 2 6.23894 0.879353 11.5248 3.88204 4.12095 -2.29502 +13 1 7.0611 5.68864 2.39703 8.93877 -14.6422 -9.86735 +14 2 6.49127 6.20844 2.93802 -15.3109 10.2002 23.1803 +15 2 6.88849 6.05122 1.53455 1.63853 6.11013 -15.8751 +16 1 16.2018 10.2111 16.0976 42.0151 -2.30245 8.02011 +17 2 17.1767 10.3828 16.1846 -31.1897 -9.90141 -8.38467 +18 2 15.8087 11.0308 16.3852 -12.3763 9.98735 1.02793 +19 1 10.6387 14.9527 2.33657 9.03987 18.5511 -2.17595 +20 2 10.545 14.5243 3.1949 1.96881 -4.62445 -0.461144 +21 2 11.2262 15.72 2.53493 -10.4825 -13.512 -5.5858 +22 1 17.1607 8.25027 10.5569 -10.4361 3.90862 15.3578 +23 2 16.8456 8.92829 11.1924 -0.168965 -8.85021 -9.39988 +24 2 17.9277 8.63713 10.1294 7.74511 3.00226 -1.55375 +25 1 14.7566 15.8542 16.4215 -9.50848 16.8449 -9.38304 +26 2 13.8265 16.1715 16.4278 14.8795 -5.02546 -3.6071 +27 2 14.9162 15.569 17.3232 -2.48975 -11.4773 7.52297 +28 1 12.1331 13.4103 0.48985 -10.556 -4.43922 -13.5861 +29 2 11.9475 13.3795 18.1761 8.0664 -0.863413 7.07636 +30 2 11.3865 13.8946 0.862316 6.65844 3.98247 10.4433 +31 1 9.29843 5.44761 4.00486 3.37284 8.34248 -28.0116 +32 2 8.80378 5.24143 4.78809 -8.97197 -9.15203 12.3932 +33 2 8.61542 5.51114 3.30134 8.62356 -3.76178 8.99247 +34 1 1.79678 4.17189 11.6321 9.86643 -30.5991 16.8051 +35 2 1.62878 5.09135 11.8205 -3.04918 18.6361 6.49963 +36 2 2.25792 3.77365 12.4221 -11.5809 11.2089 -24.12 +37 1 2.02425 6.80455 8.32417 0.209126 8.78432 0.0974623 +38 2 2.41895 7.33028 9.04952 -2.4595 -11.9319 -6.9206 +39 2 1.91003 5.89259 8.64365 4.06316 7.1017 -1.03524 +40 1 5.41039 4.42866 7.97545 15.1976 -3.31539 14.1613 +41 2 5.46063 3.46886 7.81834 -3.32316 3.28084 -1.43066 +42 2 4.8072 4.83488 7.36206 -13.6118 -1.04066 -17.9483 +43 1 3.27942 2.94296 17.507 14.649 -12.38 -13.2068 +44 2 4.01307 3.22765 16.9192 -12.2988 4.29907 8.19647 +45 2 2.92414 3.72569 17.9407 -4.7152 6.06254 1.98711 +46 1 7.44402 5.32718 6.09908 -2.23439 -3.56175 -18.7368 +47 2 8.08992 5.98284 6.3762 -3.15187 6.11466 20.9447 +48 2 6.88688 5.06352 6.84221 3.51936 -1.39652 7.32666 +49 1 9.78623 6.99393 11.9838 -8.59529 -1.09594 -12.3674 +50 2 10.3445 6.45759 11.4052 1.55365 1.23763 7.43723 +51 2 9.00985 7.18223 11.4209 7.62587 2.79809 7.26056 +52 1 14.0725 3.61727 8.08367 12.8617 -8.18347 36.7285 +53 2 14.0228 4.31343 7.45005 -3.4794 19.1063 -13.5046 +54 2 14.4179 4.02628 8.91908 -9.29791 -10.4076 -21.8094 +55 1 4.59231 17.2384 3.97449 0.493238 3.33808 0.649061 +56 2 5.51414 17.4776 4.03994 12.0557 0.622386 5.90157 +57 2 4.23063 17.8039 3.28947 -7.41249 -4.06804 -9.31956 +58 1 16.4721 16.5989 10.1846 -15.657 14.3962 29.6607 +59 2 15.672 16.8273 10.736 23.5631 -12.0212 -18.4682 +60 2 16.1719 15.9965 9.50314 -9.75188 -3.46964 -7.56259 +61 1 1.98052 4.85246 0.373619 -1.44601 4.98585 -7.77412 +62 2 2.7262 5.17853 0.894803 -2.15831 4.7879 6.78517 +63 2 1.59165 5.65237 -0.0264377 4.8265 -6.05414 -1.09652 +64 1 11.6431 13.3034 16.3099 -7.83069 14.4437 11.7005 +65 2 11.0472 12.5464 16.386 4.77345 -10.1552 -4.34879 +66 2 12.2516 13.1635 15.5747 -3.53477 -7.02177 -5.05796 +67 1 10.1531 11.0326 16.9094 -23.9188 11.6521 -2.01913 +68 2 10.5087 10.1543 16.8125 9.70699 -14.9542 1.17008 +69 2 9.18648 10.9213 16.8155 11.1855 0.742098 0.22461 +70 1 11.7413 17.4552 13.4621 -1.23374 28.315 3.5075 +71 2 12.4767 17.2116 12.8888 0.8966 -9.51431 -5.30227 +72 2 11.7922 18.439 13.4864 2.17346 -17.034 -0.823798 +73 1 6.40572 9.32656 12.214 8.55802 19.8904 20.5686 +74 2 6.90308 8.91303 11.5283 8.82473 -10.1612 -21.9185 +75 2 7.05175 9.94906 12.6124 -18.2049 -7.77814 -0.199089 +76 1 16.2334 12.8098 2.68826 14.0272 -12.5996 -1.63763 +77 2 17.097 13.226 2.50419 -12.4159 2.28924 0.929092 +78 2 15.5495 13.4898 2.7216 0.770652 8.50493 2.13384 +79 1 0.665645 12.593 5.91595 32.2246 4.40393 3.59492 +80 2 0.90587 12.5095 4.99041 5.40697 -3.98614 -5.66175 +81 2 18.3758 12.6087 5.91046 -34.4951 5.63016 -3.48792 +82 1 5.23151 16.431 18.4431 -16.7943 8.81872 -4.95242 +83 2 5.79594 15.7593 18.0508 10.3373 -8.32481 3.89376 +84 2 5.47944 16.6222 0.707356 8.36178 -5.19521 1.40492 +85 1 0.571414 7.67431 4.12619 2.94709 1.59491 -2.60127 +86 2 18.6158 8.07004 3.46977 2.09916 -2.88444 -0.00351913 +87 2 1.46322 7.94524 3.84829 -2.55586 0.342718 0.201417 +88 1 3.11705 8.93424 6.4998 54.1901 -7.8337 2.25484 +89 2 3.7667 8.5317 7.12157 -13.167 10.549 -15.4875 +90 2 2.28764 8.76575 6.88741 -36.769 -1.96533 12.6863 +91 1 7.28047 10.3297 16.2671 12.2744 -1.5589 -10.8048 +92 2 6.65751 10.5384 15.5688 -5.93087 0.719661 3.96859 +93 2 6.78418 10.1979 17.0822 -4.65586 3.14184 2.44827 +94 1 11.1311 1.01006 5.00872 -4.59838 3.25637 13.1063 +95 2 11.104 1.87564 4.56859 3.00456 -5.57579 -4.19999 +96 2 10.7195 0.375584 4.41788 -1.87117 -0.379426 -13.1931 +97 1 4.37947 2.77237 13.219 1.2209 -0.528365 -1.66794 +98 2 4.72737 3.08878 14.0495 2.85744 14.0767 5.60955 +99 2 4.20383 1.85536 13.4394 -3.83295 -12.6961 -6.71285 +100 1 8.38383 10.1509 1.80871 -12.6182 20.2791 -9.41543 +101 2 8.178 10.838 2.47049 7.2019 -6.44506 -5.42193 +102 2 8.73482 9.42727 2.30684 9.9898 -17.6863 11.9989 +103 1 10.4319 1.72481 15.5562 12.4011 -4.85254 7.43664 +104 2 11.3895 1.56158 15.4091 -17.4954 3.73262 -0.131687 +105 2 10.062 2.13812 14.7716 6.37582 -0.463351 -11.2945 +106 1 2.70803 12.8564 7.7877 0.947466 12.6679 0.63847 +107 2 3.18684 13.6562 7.51328 0.350127 -6.04869 0.642024 +108 2 1.99719 12.778 7.13709 0.576803 -6.26493 0.417134 +109 1 3.70343 11.6943 5.19413 20.2082 20.004 0.0632986 +110 2 3.58824 10.8286 5.55511 -6.2763 -16.1433 9.0068 +111 2 3.08304 11.8089 4.48497 -14.3756 -1.22762 -7.56914 +112 1 6.79775 14.44 16.9261 12.4025 3.68508 -3.36544 +113 2 7.76361 14.3574 16.912 -9.58328 3.53086 0.838276 +114 2 6.54478 14.7426 16.0399 -3.94857 -4.38541 1.40645 +115 1 14.2011 14.5459 3.3522 -3.08566 -2.84615 -1.00806 +116 2 13.6596 15.3308 3.14384 3.83224 -9.07839 4.89455 +117 2 13.7292 13.9763 3.99269 1.14293 11.3016 -6.48612 +118 1 8.39096 18.1361 16.0337 -32.316 13.1552 1.22555 +119 2 8.83502 17.3455 16.3332 22.4875 -6.85104 -0.859562 +120 2 8.9267 0.219511 15.6905 18.196 -4.39201 7.01778 +121 1 4.72714 1.63535 4.92703 -26.6842 -20.3158 26.1173 +122 2 3.8064 1.92851 4.99525 4.72714 3.40068 -1.69015 +123 2 5.07003 2.08002 4.18139 17.9323 21.4409 -28.6349 +124 1 14.9964 12.7123 16.4352 -4.22015 -14.1687 -30.4934 +125 2 14.5029 13.21 17.0522 -6.30453 18.4993 32.9687 +126 2 14.3164 12.5754 15.7407 23.1427 -3.84454 1.0347 +127 1 15.7385 18.4508 16.8675 -13.9243 -22.2803 -23.7862 +128 2 16.4074 18.4637 17.529 20.9098 4.79862 21.1737 +129 2 15.5806 17.4953 16.7298 -7.09236 11.271 1.12369 +130 1 1.21817 1.19055 16.5653 11.7565 -7.97186 -17.2906 +131 2 1.96844 1.77109 16.7379 1.96571 4.11248 6.40071 +132 2 0.658106 1.26508 17.3256 -9.62795 7.29392 16.1709 +133 1 18.134 4.50826 15.9251 -3.15057 6.2034 16.9599 +134 2 18.3539 4.06683 15.1192 3.29697 -9.24478 -15.9855 +135 2 0.215105 4.3469 16.5346 0.451532 1.5183 -0.00159427 +136 1 12.2559 16.9635 16.13 9.81693 16.417 -30.969 +137 2 11.5335 16.7255 16.6761 -27.6315 -15.1383 17.2649 +138 2 11.8852 17.008 15.2138 11.4543 -2.176 15.2032 +139 1 16.0072 2.53826 18.0715 2.86853 -7.51147 -8.26075 +140 2 15.4847 3.23875 18.4474 -1.55266 16.6686 8.62869 +141 2 15.8031 2.59593 17.1292 0.710765 -2.58084 -2.04371 +142 1 6.70782 13.8427 10.2201 -0.679857 -3.70625 -19.7607 +143 2 6.50134 13.5235 11.1067 -0.321862 -5.5215 0.0793921 +144 2 6.59662 13.1168 9.5703 -2.40279 4.60459 14.5526 +145 1 10.136 18.3381 2.74267 -18.0567 -22.0341 20.6824 +146 2 10.1719 0.451126 2.17508 1.85432 15.9621 -15.8725 +147 2 9.21984 17.9907 2.65838 20.6262 7.0183 -5.07627 +148 1 3.02443 17.7208 6.1026 17.1013 10.0229 -4.66436 +149 2 2.15568 17.711 5.71196 -13.0363 -3.14036 -7.80794 +150 2 3.59824 17.9918 5.35649 -4.18715 -9.59785 14.6662 +151 1 12.576 16.8948 8.01086 19.6337 5.92584 -6.52436 +152 2 11.8143 16.3513 7.79321 -8.3204 -4.9503 8.18666 +153 2 12.4158 17.4227 8.81259 -8.93553 -1.00079 -7.85288 +154 1 14.8883 15.2954 8.22088 18.3997 -23.9506 8.44323 +155 2 14.185 15.9366 8.136 -10.7922 9.32905 -8.87486 +156 2 15.3949 15.2296 7.38647 -11.857 13.9652 6.76292 +157 1 17.682 18.2494 0.348905 -7.91474 13.422 2.87656 +158 2 18.5411 17.7865 0.321045 -1.05993 10.3639 -2.93184 +159 2 17.7527 0.554981 0.612143 9.7328 -21.6142 -4.56589 +160 1 0.864553 10.4271 1.36107 38.8853 37.5027 -14.379 +161 2 0.108953 9.99831 1.68821 -41.9718 -23.1906 9.82059 +162 2 0.582253 11.2112 0.83245 0.481516 -18.0373 9.72219 +163 1 1.69239 12.2275 3.35367 -4.8948 -13.153 3.57872 +164 2 1.37753 11.4769 2.79371 7.82838 19.3971 -0.83705 +165 2 1.72119 13.0511 2.84994 -1.71551 -5.72989 -9.02345 +166 1 0.593488 17.2339 4.88925 5.54216 -9.27995 13.1842 +167 2 18.6577 17.9974 4.73698 -0.720643 -6.26101 15.0882 +168 2 0.46443 16.7935 5.76992 -5.72363 16.5902 -22.8723 +169 1 1.11371 0.949119 9.43078 -14.7072 -12.8067 -15.4602 +170 2 1.29442 0.455313 10.245 -0.545661 8.99323 2.98013 +171 2 0.250893 0.599212 9.12975 16.3522 9.05079 5.79158 +172 1 16.7438 2.34594 13.2927 -5.57812 -16.9062 26.8121 +173 2 16.8801 2.6271 12.4058 4.66444 4.54161 -27.0891 +174 2 16.4868 1.39796 13.2842 6.06262 14.3342 0.102967 +175 1 2.62374 15.8311 12.1325 -18.0747 14.04 -25.4855 +176 2 3.15014 15.3809 12.7666 13.9506 -11.3972 18.0386 +177 2 3.07511 15.7224 11.2774 1.07994 -2.68321 4.96368 +178 1 16.4243 15.6576 6.03755 15.9104 -4.34147 -2.36376 +179 2 17.3476 15.7161 6.33483 -8.235 -6.85341 4.18965 +180 2 16.3427 16.413 5.44101 -7.92512 0.157724 -1.18513 +181 1 5.79129 5.09168 11.8004 -4.72983 -0.0241771 3.34223 +182 2 5.24592 5.67928 12.3598 8.87085 -1.40185 -4.45321 +183 2 5.33436 4.24005 11.794 -1.89173 5.24027 0.81451 +184 1 15.1611 4.86757 0.757741 -10.8083 7.02962 -6.60621 +185 2 15.185 4.56786 1.66832 -2.59424 -2.50065 9.27943 +186 2 14.3347 5.37902 0.687967 11.9305 -6.73266 -3.44958 +187 1 16.3215 16.3801 2.08305 3.66808 -22.0917 28.3334 +188 2 16.2883 16.7145 3.0131 -8.2177 -1.24054 -23.9705 +189 2 16.5228 17.1161 1.52724 6.03518 21.1991 -10.8898 +190 1 0.258418 4.84833 3.80491 9.83943 -33.1452 17.0376 +191 2 0.435143 5.7654 3.92096 2.60191 31.4745 -0.643169 +192 2 0.932226 4.39489 4.35318 -12.3014 6.6918 -13.6862 +193 1 2.96829 15.0617 15.1396 -6.44278 -4.84309 -5.22724 +194 2 2.79942 14.7982 16.0602 -0.108783 -2.99279 -5.19286 +195 2 2.41643 15.8476 15.0194 7.7594 2.37019 3.88633 +196 1 1.13965 14.6405 9.53256 -35.9747 -40.3241 22.6064 +197 2 2.06314 14.7027 9.49112 43.1319 12.9068 -8.07313 +198 2 1.0594 13.7772 10.0119 -9.44904 20.5678 -15.2205 +199 1 13.5675 16.5961 11.5382 5.93785 -23.7105 -2.52771 +200 2 13.3768 17.2545 10.8786 -7.41053 16.3631 -3.48345 +201 2 13.1856 15.7884 11.1314 1.00946 8.65797 10.7521 +202 1 4.66618 1.4643 0.77663 11.7421 5.19522 -12.5382 +203 2 4.19094 2.00712 0.127209 -4.75679 -3.07286 5.52347 +204 2 4.08138 0.751582 1.04859 -6.60629 -1.36494 5.43578 +205 1 1.44472 18.5589 11.8552 5.89014 -29.5111 2.70443 +206 2 1.28184 0.411827 12.6654 0.0657759 4.1157 4.72514 +207 2 1.66959 17.6355 12.1243 -0.811151 21.0135 -2.36357 +208 1 11.5239 10.1243 4.0099 -6.2394 6.26334 5.03821 +209 2 11.225 10.535 3.18075 6.07738 -4.97061 3.39644 +210 2 12.4891 10.1836 4.01184 1.61922 -2.52467 0.807021 +211 1 8.27885 12.1614 3.71144 8.13123 -6.41358 -26.5436 +212 2 9.10665 12.5897 3.97429 -2.42085 2.52867 6.94663 +213 2 7.68553 12.1691 4.45091 -10.6399 7.25218 24.1014 +214 1 14.4389 4.03262 3.28382 -1.54769 2.04788 0.687462 +215 2 14.9998 3.98927 4.07922 -0.140352 3.9435 -3.93632 +216 2 13.6855 4.60992 3.49399 3.24138 -5.01437 4.30138 +217 1 5.6049 1.66195 7.51556 2.43321 19.3851 -35.7094 +218 2 4.99817 1.05358 7.93111 -11.2062 -8.09843 6.71806 +219 2 5.29033 1.73413 6.56196 15.7086 -7.98236 30.9511 +220 1 17.8679 1.11465 4.8662 -8.84521 -11.3875 -0.414623 +221 2 18.5938 1.34898 4.28573 7.92092 9.45731 -1.66923 +222 2 17.9348 1.63294 5.67672 2.41874 4.31495 -1.38437 +223 1 6.82183 9.41821 4.49596 0.331068 -0.81956 4.69879 +224 2 6.92763 9.68813 5.42975 0.55668 -5.9518 -10.6641 +225 2 7.69076 9.13696 4.17138 2.49623 1.53594 7.84385 +226 1 2.6692 14.9191 1.96889 -13.7427 -15.0981 33.3863 +227 2 3.22272 14.7135 2.75628 -3.53882 5.4164 -17.9931 +228 2 3.23582 15.271 1.30455 16.0902 7.51076 -16.3339 +229 1 17.3236 12.914 13.1856 6.20451 10.459 -3.7314 +230 2 16.5162 13.3803 13.3896 -16.2035 -4.78456 4.03007 +231 2 17.8657 13.6659 12.9192 5.22743 -7.26423 -1.93052 +232 1 14.957 10.5619 1.40158 33.4378 15.8576 14.4167 +233 2 15.5687 11.2535 1.77718 -16.3935 -17.8486 -10.6273 +234 2 14.0947 10.9454 1.47451 -15.7071 3.57407 -1.68856 +235 1 5.70225 6.80052 4.56184 6.57688 14.9147 -7.26545 +236 2 6.13296 7.68472 4.64206 -12.0226 -12.483 -2.28626 +237 2 6.28869 6.17268 5.00191 2.5554 2.13057 5.94298 +238 1 8.01258 8.29623 10.2593 -8.54796 -9.21297 9.02749 +239 2 8.56841 9.06789 10.0886 3.62647 -1.62136 -15.6888 +240 2 7.62542 7.94814 9.4343 7.03713 6.69092 4.95874 +241 1 13.441 18.4149 5.75957 4.19405 2.302 -13.2138 +242 2 12.6243 0.255994 5.52243 8.89948 -2.22339 5.88848 +243 2 13.1991 17.7887 6.44621 -5.69407 0.108635 9.70575 +244 1 0.157493 2.61527 0.174457 -9.01339 -22.8294 -0.321401 +245 2 17.938 2.88173 18.4446 6.58659 5.28303 7.29983 +246 2 0.732894 3.35773 0.380844 -2.17088 12.8237 -3.11298 +247 1 12.7457 11.0391 9.7485 36.4778 -29.6492 25.4167 +248 2 11.881 10.9734 9.40839 -39.1103 -1.43989 -11.0388 +249 2 12.9187 10.1217 10.0968 -0.290925 20.2268 -9.99681 +250 1 0.740308 12.1745 11.0603 -22.9837 8.27774 -1.01284 +251 2 18.4139 12.2368 11.1424 7.83285 -3.43363 -6.48653 +252 2 1.04445 12.5328 11.8929 13.1768 -0.7817 9.81141 +253 1 5.09631 7.29496 13.4329 -5.02176 -6.40528 2.12919 +254 2 5.65923 7.87015 12.9013 0.281799 7.42737 5.37855 +255 2 5.54275 7.21467 14.2893 3.22018 -2.41867 -5.38403 +256 1 1.21307 6.88521 11.8471 45.2055 23.2855 19.4361 +257 2 0.504281 7.33909 11.418 -17.6401 7.5893 -9.966 +258 2 1.85566 7.62216 12.1147 -28.9146 -29.9066 -6.84092 +259 1 15.4951 9.58282 12.318 3.7565 -9.08444 -2.54037 +260 2 14.9885 10.3731 12.1762 -1.60608 19.4691 -5.65324 +261 2 15.197 9.26603 13.1641 1.66558 -4.92983 10.8479 +262 1 16.5876 12.7654 5.4778 8.29992 -4.99789 29.9812 +263 2 16.3841 13.7077 5.58453 -1.61151 1.51391 -8.42869 +264 2 16.4534 12.5134 4.57091 -6.79319 5.2662 -20.9737 +265 1 6.24519 9.93185 0.0511849 19.8307 -8.34124 26.5163 +266 2 5.62326 10.391 0.623031 -8.96333 4.37615 -1.09153 +267 2 7.04636 9.86115 0.632167 -14.2701 4.68407 -14.2447 +268 1 12.3094 6.10151 4.07154 29.4526 9.60181 -18.9544 +269 2 12.3581 6.67925 3.27122 -7.72489 -2.14158 19.4346 +270 2 11.4533 5.70734 4.07903 -24.5921 -5.49884 -2.8127 +271 1 0.238725 12.7856 0.183979 8.51406 3.08383 0.253195 +272 2 0.144933 13.4932 0.833619 -6.86037 1.22763 2.8825 +273 2 18.4214 13.096 18.0418 -3.66036 2.31192 -5.9902 +274 1 3.70956 18.598 8.57987 -8.91795 8.796 11.4474 +275 2 3.55449 18.0356 7.80833 -3.96611 6.10323 -0.149317 +276 2 2.8446 0.378518 8.78385 11.2365 -8.2841 -4.38951 +277 1 7.48876 17.3305 4.49636 -9.17434 -25.7083 -0.449464 +278 2 7.67261 18.2518 4.49855 7.01126 32.4538 5.60223 +279 2 7.56532 17.0943 3.57389 -1.71949 -1.63571 -7.00131 +280 1 9.24209 17.1007 12.2607 -0.0867103 -4.31389 -13.5747 +281 2 9.30622 16.4126 11.5797 -4.40084 -0.983353 3.37399 +282 2 10.1228 17.1279 12.6444 4.44927 1.46684 7.86514 +283 1 13.3362 12.9421 7.98122 6.55916 41.1429 -16.6734 +284 2 13.3796 12.1892 8.55526 4.57885 -11.5398 14.8452 +285 2 13.9495 13.647 8.31623 -8.21726 -16.9651 -6.13203 +286 1 14.9343 2.98184 15.3399 -18.8859 -3.08059 15.3623 +287 2 14.3306 2.22694 15.2091 8.05839 6.56319 -1.64083 +288 2 15.5611 2.99492 14.6188 6.00199 -3.60128 -9.94013 +289 1 9.8611 15.5568 16.9864 -5.18568 1.15062 7.50023 +290 2 10.3014 14.7282 16.7357 2.8278 3.85059 0.776615 +291 2 9.42894 15.4199 17.8518 3.24739 -0.30663 -9.25648 +292 1 11.3089 8.34774 16.5637 -8.99518 -4.25182 3.40254 +293 2 10.6351 7.93491 15.9913 5.93093 -1.15278 9.90769 +294 2 11.3777 7.78039 17.3602 -0.876032 6.75541 -11.8921 +295 1 3.86263 18.1743 16.7605 8.31608 -24.0238 3.67333 +296 2 4.34809 17.526 17.3016 -5.03788 -1.4921 -11.4176 +297 2 3.91859 0.291346 17.3034 -3.84782 28.4328 8.21839 +298 1 2.18675 4.1526 8.92206 -24.1698 7.19476 -17.4672 +299 2 3.08777 4.02084 8.66345 19.2563 -3.88604 2.84364 +300 2 2.11989 4.14607 9.87269 6.11123 -7.11558 17.6044 +301 1 9.878 10.3743 9.69372 5.53967 -18.4491 14.0185 +302 2 9.43572 11.1423 9.3425 -1.35277 14.796 -0.820696 +303 2 10.0526 10.4842 10.6451 0.294207 2.81912 -6.3598 +304 1 9.67606 0.861397 10.8616 12.1631 -0.119776 7.34561 +305 2 9.24662 0.0503119 11.2005 -2.60905 7.79605 -9.27605 +306 2 9.17358 1.27941 10.1433 -7.66403 -7.87567 2.43043 +307 1 9.19351 15.1133 10.2188 11.11 2.94282 0.236533 +308 2 8.72034 15.7288 9.64731 -2.95318 7.0206 -0.021652 +309 2 8.61234 14.3559 10.3013 -9.273 -0.749783 0.810803 +310 1 0.983709 9.49699 10.2982 -74.1988 19.4185 4.2569 +311 2 0.893433 10.4494 10.5162 13.7438 -13.7231 -2.84852 +312 2 1.86549 9.26486 10.2468 58.3196 -6.52918 -3.90093 +313 1 16.9084 4.83943 8.1598 4.06942 21.6595 -28.8412 +314 2 16.3724 5.61591 8.36865 -1.41178 -4.09344 3.51719 +315 2 16.8393 4.26054 8.89216 -0.699807 -17.3102 23.1105 +316 1 14.7125 14.7098 0.257213 21.3866 7.73012 -2.74727 +317 2 15.2455 15.0698 0.987096 -5.24332 1.02996 -2.3964 +318 2 13.934 14.3364 0.654485 -15.8904 -6.61515 6.72623 +319 1 3.61962 11.0361 9.55343 7.54802 -1.42323 12.4812 +320 2 3.62776 11.3571 10.4773 -0.544226 1.54555 -6.56144 +321 2 3.18313 11.7186 9.01674 -3.18494 -0.813089 -1.4949 +322 1 11.1481 10.7794 1.3867 -18.0125 -13.9714 2.13506 +323 2 11.5419 11.6189 1.17487 5.50703 16.2749 -10.1623 +324 2 10.2377 10.7815 1.02242 13.9743 0.382042 6.15217 +325 1 13.1644 7.14571 12.7934 28.1674 11.2254 -0.0108115 +326 2 14.1505 7.05998 12.7803 -16.3048 -3.53009 2.57838 +327 2 12.835 6.25234 12.9024 -6.40061 -9.363 -1.95696 +328 1 9.62034 1.87073 0.979069 -6.9897 -0.645983 -14.1021 +329 2 8.86926 1.41829 0.528843 9.90899 13.9476 5.87182 +330 2 10.1257 2.37739 0.312436 -3.40486 -11.198 4.68953 +331 1 10.6367 13.5403 4.62088 -14.2461 -11.7796 -9.34504 +332 2 11.3649 12.9086 4.64313 9.4379 4.41524 3.81629 +333 2 10.614 13.9519 5.48444 4.98914 7.07 10.6976 +334 1 14.3951 1.77229 10.9373 11.882 -13.8992 0.14286 +335 2 15.2529 1.46692 10.5904 -8.80209 -5.09491 0.192719 +336 2 14.4998 2.72321 10.9422 -3.89457 8.74507 -1.42899 +337 1 14.6035 12.2778 11.6732 8.28457 -2.47972 34.5189 +338 2 15.3822 12.4706 11.1386 -1.8445 -1.29245 -12.2333 +339 2 13.8238 12.1274 11.1597 -9.6117 -2.29221 -24.4043 +340 1 8.21682 5.05944 9.82725 33.2235 -12.7421 -22.1109 +341 2 7.50249 5.31613 10.3805 -26.8995 -2.6371 14.604 +342 2 8.16278 4.09579 9.61432 -6.39419 19.305 4.57693 +343 1 1.57178 16.8746 18.3696 -12.5949 -28.7752 19.8992 +344 2 1.95856 17.2997 17.6256 12.4489 12.7929 -23.944 +345 2 1.61191 15.9133 18.1414 3.74732 18.7705 7.54273 +346 1 1.50483 17.2622 15.3369 -31.2805 -0.211241 0.372367 +347 2 1.56428 18.1715 15.7008 -8.02099 -13.4799 -3.86937 +348 2 0.550545 16.944 15.3287 29.8388 16.9503 2.40621 +349 1 3.67189 5.70682 6.10259 2.52977 5.35962 -6.45813 +350 2 3.10512 6.24939 6.65687 -5.8484 1.84291 7.09291 +351 2 4.11645 6.33532 5.504 1.86189 -8.61654 4.18176 +352 1 12.4205 9.46682 14.1922 0.00765934 6.29699 5.01976 +353 2 12.7713 8.66673 13.7826 1.27338 -5.49384 -0.333278 +354 2 12.2037 9.20626 15.0998 2.51081 -2.42178 -0.168732 +355 1 4.04257 15.2822 6.8914 -27.6779 4.92775 8.06061 +356 2 3.56316 16.0906 6.63798 2.42102 -8.57509 -1.16647 +357 2 4.95231 15.5118 6.77617 25.3206 1.78005 -4.31003 +358 1 0.630616 8.59357 14.9621 0.0534875 13.3347 6.63524 +359 2 0.475879 9.54739 15.0951 0.802494 -5.58418 -0.636111 +360 2 1.32488 8.5708 14.2996 4.58301 -1.27906 -6.75903 +361 1 12.9988 8.28033 10.3217 -21.3611 19.4324 1.5895 +362 2 13.6573 7.74741 9.88515 12.8548 -10.016 -2.83384 +363 2 12.9714 7.9897 11.246 0.968107 -4.04745 -5.09921 +364 1 15.3184 7.7322 3.54707 4.18654 -9.90345 10.9868 +365 2 14.6375 7.17364 3.22195 -21.9236 0.488691 -25.4272 +366 2 15.542 7.2045 4.31452 16.9904 15.0521 14.7627 +367 1 17.298 6.68564 0.0426033 13.9193 -14.0885 -0.920406 +368 2 16.8642 5.82471 0.139777 0.0396094 5.05794 2.76644 +369 2 16.6003 7.28204 18.4358 -17.9105 11.3609 -4.38582 +370 1 8.85442 6.93876 7.83202 25.5204 20.9839 -12.9835 +371 2 9.78415 7.28149 7.87459 -21.3181 -5.86923 -3.23496 +372 2 8.81067 6.25344 8.49096 -5.61401 -13.4392 14.4413 +373 1 12.3763 0.596552 1.22002 -1.17453 2.99561 6.82033 +374 2 13.3385 0.528874 1.30915 -5.26207 -0.953155 0.827968 +375 2 12.0852 0.273415 0.369127 5.54968 -2.26078 -4.64309 +376 1 5.63283 15.1348 14.5573 -11.4131 -7.08845 -3.56826 +377 2 4.66833 15.2302 14.6984 9.61439 -4.03287 3.27369 +378 2 5.92452 15.9751 14.1944 7.77409 8.39082 -1.96781 +379 1 3.86657 6.44559 1.75085 5.80409 -14.6499 1.98717 +380 2 3.55249 7.31671 1.4889 -5.45171 9.45984 0.647045 +381 2 4.14269 6.4981 2.68117 -5.39897 6.08822 -6.8935 +382 1 3.91507 11.6157 12.3486 -13.4135 -1.42429 5.74998 +383 2 4.7693 12.0145 12.538 6.44699 -0.479912 -1.2837 +384 2 3.27735 12.1325 12.8813 7.77399 -7.15276 -11.5357 +385 1 5.36262 3.86651 15.8768 12.1389 -59.3419 -3.52329 +386 2 6.1064 3.19888 15.7551 -26.8485 22.8054 1.66706 +387 2 5.75212 4.71249 15.8089 15.627 34.646 -1.2618 +388 1 14.3819 10.2457 4.44716 -17.5064 5.46907 41.0935 +389 2 14.5449 9.71992 5.26671 -1.94493 10.8322 -14.5796 +390 2 14.8723 9.82528 3.76702 14.2142 -16.5996 -23.0963 +391 1 7.82031 17.402 9.18196 15.4978 -20.6961 5.52716 +392 2 6.95708 17.6159 9.5372 -6.73409 6.75657 -1.79958 +393 2 8.0438 17.9374 8.41052 -8.48575 5.6988 -1.01071 +394 1 4.52697 14.5011 3.99561 -1.64824 1.80571 -15.4173 +395 2 4.43911 15.4257 4.28139 2.0309 -4.99506 3.13673 +396 2 4.3827 13.9072 4.73582 -0.0495062 -0.930109 11.2178 +397 1 14.2192 7.41869 15.785 -17.5888 -3.59777 -10.979 +398 2 15.1626 7.35697 15.6947 20.631 -1.7403 -3.62609 +399 2 14.073 7.80524 16.6426 0.667235 5.42077 11.7037 +400 1 2.9565 18.2605 1.91108 1.19197 -18.909 -26.3864 +401 2 2.43337 17.7432 1.2423 11.354 8.34367 16.4878 +402 2 2.37308 0.276014 2.2689 -15.3488 13.3111 9.03739 +403 1 8.00359 1.60253 4.55907 -38.5212 -7.91491 7.83452 +404 2 7.38229 2.10405 3.99193 12.1921 -3.74558 1.60605 +405 2 8.88232 1.74243 4.26439 24.0023 10.0694 -13.3902 +406 1 2.4736 14.1336 17.6839 19.5549 7.85258 6.07398 +407 2 1.90347 13.5339 18.1719 -6.00167 -6.95039 -0.586477 +408 2 3.38553 13.9045 17.9683 -9.72011 -2.72883 -0.373401 +409 1 0.820064 1.73894 13.8888 -18.5285 5.33114 2.4032 +410 2 0.803771 1.49328 14.8397 -2.66487 6.43341 -16.8821 +411 2 18.5531 2.02517 13.6233 21.0072 -9.49287 13.5993 +412 1 4.44957 0.0409644 13.9204 -25.6038 8.03756 8.31677 +413 2 5.34611 18.3721 13.8825 17.1601 -8.5878 1.82821 +414 2 4.09536 18.4705 14.8092 8.9848 -0.155186 -10.4675 +415 1 7.11939 0.665063 18.3496 37.4596 -16.3367 -22.9959 +416 2 7.39046 0.248229 17.4868 -7.59422 10.3961 22.0522 +417 2 6.17976 0.73857 18.3349 -24.6121 7.91301 3.99406 +418 1 16.0679 18.4255 14.0033 46.948 4.07246 14.5496 +419 2 15.1925 18.2569 13.7481 -41.7006 -8.82757 -2.39817 +420 2 16.1514 18.46 14.9783 -11.5795 5.15321 -10.1321 +421 1 10.0899 4.51466 16.2755 46.1692 31.6348 -9.79269 +422 2 11.0262 4.80528 16.0633 -26.3332 -3.27592 13.4521 +423 2 10.217 3.58436 16.3451 -11.2214 -29.3564 0.661634 +424 1 15.916 17.7977 4.41903 32.6965 1.49817 -6.30174 +425 2 16.457 -0.0326327 4.45612 -4.70593 -7.03645 1.74937 +426 2 15.0663 18.0576 4.73092 -30.5769 8.16516 8.13282 +427 1 7.01211 17.4116 13.808 -11.1093 -0.0306798 -7.53718 +428 2 7.48321 17.731 14.5797 1.71822 -1.35338 6.01299 +429 2 7.70771 17.2257 13.1599 -0.832239 2.47859 1.40448 +430 1 13.2731 6.49483 6.63036 5.49864 12.0855 21.8831 +431 2 14.0036 7.1367 6.53142 -6.95912 -13.4785 -6.50558 +432 2 12.9191 6.26998 5.7719 1.78547 5.07661 -13.1828 +433 1 7.78873 2.35817 9.26787 13.6578 7.92928 32.9359 +434 2 7.26595 2.28464 10.098 4.41261 -4.66671 -14.4408 +435 2 7.24114 2.08424 8.54668 -18.4281 -7.28868 -15.4379 +436 1 15.1807 14.8213 13.6836 12.0158 -14.5979 1.51453 +437 2 15.023 15.1631 14.5679 -5.44227 3.64048 5.06686 +438 2 14.7818 15.3898 13.0312 -8.03448 9.52233 -3.65179 +439 1 9.37687 8.31604 3.76928 5.34304 4.19186 5.02399 +440 2 10.2244 8.59911 4.15846 -6.46746 6.21109 -7.45595 +441 2 9.38739 7.36131 3.86692 -0.369722 -6.10407 -0.56198 +442 1 17.7826 13.5587 16.3931 -18.259 -13.3606 7.93732 +443 2 16.8564 13.2543 16.3515 3.23179 3.05811 2.18424 +444 2 17.7493 14.412 15.956 6.45918 8.6709 -4.68033 +445 1 4.96945 10.6182 2.7671 -20.0352 21.3698 -14.9929 +446 2 5.67156 10.2863 3.30832 14.7689 -7.42384 15.9186 +447 2 4.73305 11.5 3.12196 4.54065 -18.1741 -2.81522 +448 1 3.75186 8.34553 10.1595 -2.54049 11.5371 -18.7835 +449 2 3.83158 9.28658 9.87851 -1.62744 -10.9109 6.60301 +450 2 3.69687 8.33176 11.111 2.12623 4.07512 13.0596 +451 1 16.0105 7.02075 6.14683 -8.93467 17.9282 -2.69417 +452 2 16.8191 7.42843 6.45697 9.04966 6.41713 2.22097 +453 2 16.1641 6.09023 6.1704 3.21598 -21.4167 -2.94797 +454 1 15.1148 7.07457 9.06702 4.51295 -11.3361 21.5265 +455 2 15.7278 7.43111 9.72685 3.64545 -0.886375 -6.04752 +456 2 15.1684 7.6713 8.33808 0.281889 14.352 -20.2518 +457 1 6.32562 13.0044 12.7823 3.64263 -12.4915 -10.2251 +458 2 7.18031 12.5985 13.0233 -9.44077 2.88231 5.28619 +459 2 6.10277 13.6925 13.4113 4.07235 10.5841 12.4872 +460 1 12.13 4.50388 13.0978 -23.9143 -18.2098 -29.5576 +461 2 12.2018 4.66005 14.0386 -4.52664 -3.61945 12.4396 +462 2 11.31 3.95423 12.8708 29.5104 21.9629 17.7949 +463 1 11.3628 8.1671 7.89263 -5.63688 4.26156 -3.21905 +464 2 12.0486 7.63378 7.48497 5.26632 -9.68169 -9.18733 +465 2 11.6596 8.25059 8.79652 3.08614 3.11673 13.4283 +466 1 17.1728 10.8467 7.48683 -9.78257 9.61375 -3.53187 +467 2 17.8082 10.1926 7.21604 13.2987 -16.4259 3.23364 +468 2 17.1151 11.4269 6.71399 -11.2446 1.98681 4.69156 +469 1 5.26156 18.1118 11.0164 11.279 0.780011 3.76881 +470 2 4.63029 17.9037 11.706 -3.79608 -1.61163 6.00067 +471 2 4.75114 18.4846 10.3039 -10.5863 -2.03901 -14.6626 +472 1 7.60927 17.5116 1.80376 -12.2084 0.332405 -16.0787 +473 2 7.73547 16.6894 1.27511 4.49641 20.7738 7.60921 +474 2 7.29137 18.2078 1.17993 10.7818 -15.1152 7.96202 +475 1 1.93242 12.9038 13.5907 -11.1009 -8.62515 -2.91716 +476 2 1.44204 12.3193 14.1878 -0.742257 0.132846 -0.79095 +477 2 2.14259 13.6778 14.1103 6.96653 11.7909 8.84583 +478 1 9.6349 6.79099 14.8483 -7.90933 -4.5792 7.57822 +479 2 9.76837 5.84646 15.0736 0.917781 12.494 -4.6794 +480 2 9.97866 6.97841 13.9703 0.736717 -7.57275 -8.26148 +481 1 15.2733 4.3257 10.7584 -18.0594 -0.89979 -6.45033 +482 2 16.1458 3.96681 10.9687 3.533 12.3702 4.36819 +483 2 14.9475 4.94569 11.4317 15.7147 -3.56113 0.605423 +484 1 11.2438 6.16931 0.179082 0.0277951 -2.16566 -3.90965 +485 2 11.3357 5.30361 18.4317 14.8036 -12.0621 -1.88578 +486 2 10.2956 6.2638 0.1816 -11.5861 14.503 2.02073 +487 1 0.0439986 11.3816 15.0585 -6.49496 4.09431 2.20477 +488 2 18.034 11.5578 14.353 7.75523 3.54925 4.26198 +489 2 -0.111373 12.1024 15.7029 3.25408 -7.01329 -10.5532 +490 1 7.06114 9.23722 7.26386 23.5376 12.3273 -0.106793 +491 2 6.50127 8.56776 7.63843 -10.2441 -19.5548 5.03643 +492 2 7.97426 8.90952 7.38371 -13.166 2.65106 -3.29749 +493 1 18.3483 15.3728 12.3401 -6.10947 1.64082 -0.490965 +494 2 0.640544 15.4003 12.1341 13.3619 2.30286 0.418231 +495 2 17.9315 15.8707 11.6253 -4.70162 -1.66258 -3.35097 +496 1 16.5284 4.37134 5.23872 23.865 15.8443 -24.0922 +497 2 16.795 4.23475 6.13242 -1.17196 -10.8972 27.7735 +498 2 17.3848 4.63349 4.80865 -25.3878 -11.1359 -1.24016 +499 1 17.7266 3.13043 10.7284 -15.1505 -16.4799 -4.03799 +500 2 -0.0205156 3.31599 11.0266 10.8372 -1.61224 -0.261482 +501 2 17.686 2.21262 10.3629 5.98361 15.5222 5.29053 +502 1 12.2768 0.00077952 10.1229 -5.39949 -11.0736 -0.564535 +503 2 11.3994 0.337416 10.3512 -3.44242 -0.519791 1.58275 +504 2 12.8621 0.740723 10.2534 12.1364 13.942 1.61795 +505 1 10.3933 9.78571 12.4371 -17.696 -6.66554 -9.33286 +506 2 11.04 9.8019 13.1479 9.02187 0.111511 2.28178 +507 2 10.1583 8.84624 12.3274 6.95171 5.58218 -0.582165 +508 1 0.583846 2.83323 7.01904 8.81732 -31.8654 7.83245 +509 2 0.599611 3.49885 7.68934 -3.58556 22.6003 9.07619 +510 2 0.952398 2.07883 7.51841 -6.10214 6.37924 -11.0018 +511 1 0.367433 15.2949 6.92522 -4.7012 3.61818 34.4112 +512 2 0.558547 14.7156 7.70153 -1.71176 22.246 -5.06421 +513 2 0.60814 14.7658 6.19753 10.4713 -26.0103 -27.8181 +514 1 17.0409 7.00624 15.2099 -22.5014 1.92016 -1.24665 +515 2 17.7387 7.65639 15.0691 10.2085 -5.07189 3.59706 +516 2 17.3996 6.21947 15.6455 8.09739 1.82665 -3.45815 +517 1 9.08645 12.4582 8.07298 60.2845 4.68897 0.226728 +518 2 9.45122 11.8173 7.41895 -17.2892 5.38378 7.41181 +519 2 8.16079 12.445 8.11596 -46.4448 -7.25102 -10.4423 +520 1 1.26434 1.84534 2.97351 6.14985 -4.32801 10.6126 +521 2 0.602074 2.03133 2.30849 -1.31532 11.5451 -8.74279 +522 2 1.61884 2.681 3.33622 -3.80121 -10.2767 -5.51985 +523 1 4.10472 15.1163 9.79145 -1.9934 -0.675971 8.59173 +524 2 4.064 15.4281 8.88095 5.53492 -3.39313 -4.80569 +525 2 4.98866 14.7298 9.93327 -5.1567 4.83883 -4.62826 +526 1 7.25259 2.18349 14.6213 0.0617677 -13.2081 -4.74626 +527 2 7.15489 1.70536 13.7831 -3.1697 0.657011 7.79217 +528 2 7.60954 3.02479 14.3607 5.63067 15.2107 -2.58221 +529 1 18.5424 14.6505 2.1789 -18.2195 12.8357 -3.23587 +530 2 0.746704 15.0923 2.14855 14.3998 1.01071 2.70778 +531 2 17.888 15.3836 2.15154 2.4051 -14.4939 -0.146303 +532 1 9.96619 2.7451 12.9133 2.94451 10.1866 18.8487 +533 2 9.87163 2.03702 12.2777 -5.79326 -7.02869 -14.8001 +534 2 9.15272 3.27293 12.9211 3.46257 -1.15836 -6.04557 +535 1 2.89008 8.93457 13.069 -0.378913 -4.03455 -0.489948 +536 2 3.23396 9.82093 12.8894 1.3587 3.50504 -2.14294 +537 2 3.63423 8.44035 13.4383 1.00579 -2.11175 -2.13579 +538 1 3.23705 8.4538 3.70316 6.66602 15.0067 -51.1451 +539 2 3.68898 9.21355 3.2191 -13.1992 -22.9024 22.1933 +540 2 3.37321 8.55056 4.62635 6.35333 11.1623 30.2444 +541 1 5.63533 7.19464 8.56829 15.13 5.19196 -11.3333 +542 2 5.75579 6.23215 8.63413 -6.09463 5.83127 4.58457 +543 2 5.06463 7.50349 9.27803 -5.30623 -7.19668 4.50769 +544 1 14.8805 1.37043 1.98087 -12.9306 20.6627 -0.801435 +545 2 14.4834 2.20569 2.28334 5.69168 -11.9007 13.5915 +546 2 15.1168 1.59638 1.09054 15.1066 -6.121 -14.4277 +547 1 8.35206 15.1867 0.801551 -2.76223 -14.7585 -5.29804 +548 2 9.12264 14.9643 1.32951 11.031 8.33032 8.58299 +549 2 7.67017 14.6008 1.15941 -5.63761 -0.337967 -3.00039 +550 1 15.5896 1.3528 7.2086 5.32958 13.3681 13.2076 +551 2 15.0272 0.817571 6.66531 -11.4451 -13.4108 -9.89715 +552 2 14.9993 2.0562 7.52457 4.21653 3.3566 -1.64766 +553 1 5.02591 13.0452 18.4884 -9.20414 -3.59717 -21.6247 +554 2 5.46138 13.1397 0.681872 7.63488 2.92653 16.7381 +555 2 5.72796 13.1696 17.8326 -7.15584 3.38504 4.08457 +556 1 15.3795 8.51367 18.1423 -0.613664 -0.0581633 13.6311 +557 2 15.7206 8.99589 17.3938 3.47957 9.7554 -12.9134 +558 2 15.3333 9.18442 0.205917 -4.60531 -6.1888 -2.54679 +559 1 12.0939 3.05244 18.336 -15.98 21.6351 4.66001 +560 2 12.5019 2.66242 0.476891 0.147771 -8.75739 -8.71627 +561 2 12.3559 2.60872 17.5248 9.46456 -12.7769 5.34739 +562 1 13.1875 12.6757 5.16147 -9.52799 6.20775 -2.46737 +563 2 13.6969 11.8811 4.95337 3.5398 -1.69434 3.58065 +564 2 13.2525 12.8475 6.11376 6.90446 -8.64397 -1.04625 +565 1 6.03627 7.1613 0.0926319 -1.4976 11.1377 0.14104 +566 2 5.76921 8.10211 0.154014 9.70457 -9.32393 -3.08293 +567 2 5.20613 6.68485 0.159604 -1.55619 -3.41243 3.21991 +568 1 17.685 15.9184 14.9825 -1.37425 0.537856 -17.3926 +569 2 16.8502 16.3506 14.966 -20.4161 12.6054 20.7942 +570 2 17.7239 15.7506 14.0369 24.1644 -10.6132 -5.26117 +571 1 13.1805 0.948047 16.6125 -8.26177 1.73564 3.5107 +572 2 14.0455 0.715926 16.9626 7.25254 0.595142 -3.17693 +573 2 12.7267 0.0993777 16.5408 2.533 -1.4889 -4.3323 +574 1 11.0204 14.5878 7.33132 -13.7805 -25.7938 -0.586216 +575 2 10.2983 13.987 7.62969 9.87943 15.8321 -1.01987 +576 2 11.8217 14.058 7.45361 -0.254224 3.6388 3.5388 +577 1 17.5119 8.53957 2.08465 9.75653 -12.9638 -10.6953 +578 2 16.6633 8.36471 2.52368 3.0717 -2.74041 -4.8374 +579 2 17.6343 7.8268 1.40004 -7.84255 17.4574 20.9547 +580 1 12.3495 7.93856 1.97915 15.2682 -24.1922 3.95646 +581 2 11.8245 8.73298 1.97607 -8.33179 10.3297 -5.28986 +582 2 12.0289 7.32679 1.29658 -2.64171 9.95394 1.06163 +583 1 11.9622 14.6462 10.3592 5.19436 44.1652 25.6085 +584 2 12.1561 13.8266 9.98193 3.67183 -41.4058 -22.2867 +585 2 11.0169 14.8072 10.2884 -7.2612 -3.28322 -4.25289 +586 1 6.85285 6.99572 15.5659 -14.0155 -24.0568 -12.8099 +587 2 7.75988 6.91015 15.2685 9.48733 7.04308 1.07731 +588 2 6.80041 7.76332 16.11 4.63477 18.9896 15.1539 +589 1 8.01222 4.65145 13.4113 -36.8067 -34.3033 -31.6859 +590 2 7.3316 4.83402 12.7007 16.1602 -3.60309 24.697 +591 2 8.38377 5.47541 13.6286 15.6027 34.5994 6.21753 +592 1 13.4241 12.174 14.3057 -4.84328 6.02619 2.2323 +593 2 13.1628 11.2453 14.2138 0.984992 -0.986947 -4.38535 +594 2 13.8661 12.446 13.4834 -0.550032 -4.72607 1.54363 +595 1 14.7341 9.44221 7.2791 -5.07947 3.15833 13.2143 +596 2 15.5444 9.94699 7.52972 -16.5583 -4.09464 -2.76463 +597 2 13.9842 9.66778 7.87655 21.0159 1.38057 -11.435 +598 1 12.706 16.9897 3.14089 12.6698 -33.6085 3.29803 +599 2 12.7844 17.2146 4.05845 5.40916 5.57996 15.4808 +600 2 12.1668 17.6603 2.78193 -20.8699 29.0634 -19.4792 +601 1 1.09001 7.14262 17.4001 -13.5934 2.13623 7.48936 +602 2 0.156991 7.24832 17.6908 14.7769 -7.58529 -2.77652 +603 2 1.13731 7.55625 16.5284 -2.3111 1.37932 -0.487878 +604 1 12.8562 5.06495 15.6988 -8.68567 -0.702669 -5.76624 +605 2 13.5471 4.4122 15.5538 8.1837 -6.12965 4.55719 +606 2 13.3218 5.91347 15.6395 -0.893164 2.09785 3.54679 +607 1 2.45402 3.36746 5.11563 -15.0026 -7.91555 0.636238 +608 2 1.84292 3.24382 5.86687 4.72922 -2.7794 -8.95345 +609 2 2.91216 4.18226 5.3072 9.55717 10.9124 5.44962 +610 1 8.31869 11.1649 13.5414 -26.3953 31.2189 -67.0184 +611 2 8.3305 10.9362 14.4299 14.6498 -23.9054 54.2316 +612 2 8.96182 10.7076 12.9898 15.0794 -7.45176 14.931 +613 1 12.9219 1.43726 13.3082 8.40674 -27.4269 12.3988 +614 2 13.6356 1.33586 12.6838 7.08718 -5.3 -10.143 +615 2 12.6036 2.28403 13.0872 -17.61 33.9058 -2.44667 +616 1 6.45277 13.6094 2.15178 17.7292 -13.553 0.669437 +617 2 5.88225 13.9257 2.84987 -12.2826 9.62032 8.12495 +618 2 7.05696 13.0019 2.62135 -3.25561 7.9246 -7.28354 +619 1 15.9319 6.53462 12.7261 -1.3149 8.22476 -13.019 +620 2 16.4256 7.00237 12.02 -4.18033 -7.18445 13.3481 +621 2 16.3662 6.74364 13.5705 0.249391 -3.37031 -2.78146 +622 1 16.8119 0.703827 9.59317 0.0549178 13.2549 -11.7388 +623 2 16.9772 18.4048 9.65541 -4.88295 -11.6626 5.05601 +624 2 16.4803 0.847119 8.68154 -1.08178 -1.2883 7.79904 +625 1 6.11652 11.6489 8.33522 -7.45125 2.78057 4.10213 +626 2 5.22601 11.4682 8.68918 7.08294 1.77705 -0.544493 +627 2 6.44454 10.7788 8.07724 4.19277 0.895061 -4.04259 +628 1 2.82334 8.71064 0.367814 57.5944 7.33247 25.2144 +629 2 2.2601 8.16366 18.5098 -36.527 -13.587 -20.7071 +630 2 2.37171 9.41868 0.829256 -17.9324 0.137834 -3.43482 +631 1 10.1122 10.4601 6.54653 2.23323 -6.08635 8.59596 +632 2 10.5188 9.74717 7.06727 -1.60105 2.20328 -1.71973 +633 2 10.6949 10.5759 5.79445 1.91861 -2.10956 -11.6412 +634 1 6.75321 15.7504 6.59889 15.4627 0.902891 -8.22878 +635 2 7.26857 15.9454 7.3825 -2.17992 1.48032 8.28293 +636 2 7.22097 16.2558 5.90647 -13.1985 0.138133 2.05084 +637 1 6.44152 13.0383 5.65846 10.3967 8.14078 0.466175 +638 2 6.75357 13.9433 5.8413 -7.70657 -8.59676 1.70002 +639 2 6.06189 12.7174 6.48437 -0.213232 -3.44089 0.434225 +640 1 16.7867 12.5398 9.78373 -0.895423 12.3409 14.8939 +641 2 16.908 11.9251 9.05274 5.68732 0.178616 -8.50939 +642 2 17.2058 13.3939 9.58039 -4.06144 -12.2084 -5.14549 +643 1 6.11722 2.93773 2.78358 1.28645 13.216 -7.71479 +644 2 6.25944 3.86133 2.4934 3.99356 -9.45804 11.966 +645 2 5.80949 2.50246 1.9813 -4.27697 -8.38821 -0.209888 +646 1 10.8697 3.19981 3.26527 3.50346 -2.80617 2.55973 +647 2 10.3917 4.00785 3.47818 -6.11785 -2.03152 -1.59068 +648 2 10.4869 2.83625 2.45753 -2.48553 0.910808 2.03729 +ITEM: TIMESTEP +50 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.80494 6.94654 17.8995 24.4982 -1.06408 -3.00226 +2 2 7.9626 7.14317 18.2754 -25.5132 0.779993 7.28642 +3 2 8.754 6.09075 17.4755 -3.81212 -4.80634 -6.17786 +4 1 18.7076 8.28828 6.77862 -17.6183 19.7289 -45.7057 +5 2 0.378325 8.05756 5.8509 -9.14495 4.02657 32.4311 +6 2 0.533056 7.77742 7.41073 20.0311 -22.8668 16.2585 +7 1 8.47587 18.7144 6.8555 -15.9357 -0.720841 9.56566 +8 2 9.33674 0.260611 6.50709 17.8925 2.772 -5.71063 +9 2 7.894 0.699709 6.41588 1.40147 0.745568 -0.352682 +10 1 6.55032 1.74908 11.6806 -30.6389 -0.0206495 8.42613 +11 2 5.72229 2.20254 12.0188 30.9536 -14.8428 -8.23206 +12 2 6.26581 0.83583 11.4478 2.55871 18.5754 3.76962 +13 1 7.01034 5.66598 2.40366 42.8029 -38.9731 -13.6875 +14 2 6.35895 6.02285 2.96016 -30.9745 25.4116 27.1882 +15 2 6.9342 6.07183 1.55014 -9.7244 15.1829 -13.9093 +16 1 16.2046 10.2277 16.1038 24.2393 -12.7483 3.49627 +17 2 17.1446 10.5017 16.2161 -25.4373 -4.23616 -6.12234 +18 2 15.647 10.9645 16.3441 -0.0961828 13.5193 2.91036 +19 1 10.6483 14.9468 2.32679 16.6528 15.7411 4.7381 +20 2 10.6274 14.3584 3.09768 -0.623134 4.2367 -1.18236 +21 2 11.2712 15.6715 2.59359 -14.1521 -13.9994 -5.33424 +22 1 17.1661 8.23718 10.6306 -11.2967 1.73071 14.301 +23 2 16.7507 8.8212 11.3018 1.93853 -3.53361 -12.158 +24 2 17.9019 8.73965 10.2686 8.0864 2.26419 -0.719652 +25 1 14.7146 15.8737 16.457 -21.3602 13.4439 -13.9077 +26 2 13.7676 16.1527 16.3582 25.6738 -5.80999 2.03747 +27 2 14.7447 15.4629 17.3289 2.78446 -2.53877 0.107495 +28 1 12.1127 13.3961 0.516068 7.29043 -9.0569 -3.36162 +29 2 11.9491 13.4845 18.198 -4.88029 1.64951 11.237 +30 2 11.4672 13.8878 1.04861 1.29785 5.2885 -8.15688 +31 1 9.32313 5.46813 3.97213 7.80738 6.41636 -30.8752 +32 2 8.77956 5.22076 4.69796 -14.0602 -7.63701 27.6376 +33 2 8.66617 5.58024 3.26537 2.47672 -2.22308 0.129141 +34 1 1.75935 4.12111 11.6197 18.1342 -37.205 15.7411 +35 2 1.54791 5.00495 11.8916 -2.97584 25.4072 4.68628 +36 2 2.32145 3.72177 12.3424 -17.0092 10.631 -21.3466 +37 1 2.03979 6.80407 8.28533 9.98525 11.4794 16.6393 +38 2 2.53906 7.28349 8.98677 -9.97253 -7.08615 -13.1486 +39 2 1.84044 5.93856 8.67612 2.99865 2.8006 -7.53122 +40 1 5.41368 4.4431 7.98609 2.04847 -7.17668 -5.4397 +41 2 5.52021 3.53426 7.6768 1.69988 -8.04832 10.7211 +42 2 4.8597 4.83563 7.32005 -13.574 8.98698 -13.1921 +43 1 3.28639 2.94557 17.481 18.7711 -22.2673 -22.0629 +44 2 3.9564 3.24513 16.8336 -6.74837 -1.29983 9.82734 +45 2 3.01936 3.73284 17.9334 -14.3576 17.7403 14.3716 +46 1 7.43065 5.38409 6.1108 -4.02947 -12.3157 -7.88053 +47 2 8.04294 5.88377 6.62432 18.8075 23.5792 8.00277 +48 2 6.91671 4.96856 6.79731 -10.3369 -11.1081 4.55684 +49 1 9.79016 6.98523 11.9902 -10.4204 5.88316 -11.2143 +50 2 10.3735 6.44493 11.4296 -8.50476 3.87141 4.17676 +51 2 9.02941 7.28204 11.4255 18.3189 -8.29917 9.01359 +52 1 14.0741 3.64931 8.08693 10.5401 -0.215179 40.0548 +53 2 14.0167 4.44403 7.56769 -3.75439 10.9765 -10.3635 +54 2 14.3054 3.9684 9.00291 -5.13065 -9.75311 -28.2231 +55 1 4.53282 17.2396 3.96388 -3.36194 -12.9595 16.5635 +56 2 5.47422 17.3897 3.95236 14.0752 8.1678 -3.62607 +57 2 4.10275 17.6636 3.22639 -0.935466 5.38311 -16.6052 +58 1 16.4462 16.5922 10.2581 -38.5234 -1.88036 17.4962 +59 2 15.5721 16.6729 10.7424 33.2408 0.640367 -11.4138 +60 2 16.1948 16.0519 9.4989 1.36351 -0.703045 -4.07641 +61 1 1.99534 4.82647 0.326236 -5.72725 6.00108 -15.6714 +62 2 2.53752 5.17962 1.03714 5.87953 4.50688 4.90779 +63 2 1.76739 5.60304 -0.220726 -2.02535 -4.08014 4.56707 +64 1 11.5531 13.2812 16.3325 -4.55485 8.80091 5.86354 +65 2 11.0534 12.4701 16.4457 -6.69668 -7.45166 4.31247 +66 2 12.0841 13.1031 15.5561 8.82157 3.01133 -6.78989 +67 1 10.1577 11.0139 16.8858 -24.3839 23.6532 0.592397 +68 2 10.5791 10.1721 16.8528 10.3809 -28.4273 -2.47871 +69 2 9.20446 10.8554 16.7431 9.15295 -0.788439 1.53623 +70 1 11.769 17.4436 13.4724 -4.31264 31.1905 -3.85112 +71 2 12.3451 17.016 12.8258 4.51875 -1.42135 -0.782751 +72 2 11.9049 18.418 13.331 2.02313 -21.8103 4.25856 +73 1 6.43699 9.33747 12.2016 -14.3685 16.3251 29.571 +74 2 6.95929 8.94901 11.512 13.8657 -1.33735 -10.2504 +75 2 6.99936 9.91985 12.7612 -5.52999 -10.4188 -15.163 +76 1 16.2506 12.8362 2.68463 10.4823 17.07 -2.68352 +77 2 17.0784 13.3466 2.55935 -9.20242 -14.0812 1.4249 +78 2 15.565 13.5285 2.65461 0.126865 -8.38924 5.57615 +79 1 0.688432 12.6159 5.91845 40.3739 4.73102 13.6953 +80 2 0.965548 12.5027 5.00914 1.60296 -4.44104 -10.7732 +81 2 18.4099 12.7183 5.90627 -44.0147 0.977299 -7.7541 +82 1 5.23962 16.4285 18.4285 2.37714 -1.84876 8.0205 +83 2 5.78786 15.7427 18.0572 3.65919 -12.8888 -12.968 +84 2 5.57695 16.4825 0.678793 -3.22986 7.92557 6.36641 +85 1 0.598604 7.70507 4.14138 -20.7786 -13.2635 7.16681 +86 2 18.6305 8.09263 3.50172 -0.345103 1.12768 -4.13337 +87 2 1.46117 7.8354 3.77399 24.2365 9.84596 -7.22116 +88 1 3.12664 8.94501 6.49467 58.7355 2.96877 -21.5552 +89 2 3.79065 8.46432 7.02112 -12.6266 6.35685 -1.15291 +90 2 2.29097 8.86083 6.88074 -41.9399 -6.12221 23.1652 +91 1 7.26988 10.3368 16.2836 11.5372 -0.463039 -18.2668 +92 2 6.61986 10.5879 15.6307 -2.48374 3.02842 -3.04887 +93 2 6.78814 10.3049 17.1036 -3.00573 -3.18181 16.2709 +94 1 11.123 0.978368 5.0094 -10.4546 8.12706 3.20432 +95 2 11.0717 1.86722 4.62246 7.34447 -2.45893 1.30193 +96 2 10.765 0.419141 4.31729 -2.84542 -7.68945 -6.73121 +97 1 4.36745 2.7997 13.2283 -2.96005 27.1446 -27.16 +98 2 4.67681 3.13482 14.0684 -0.492375 -1.19152 9.60175 +99 2 4.17697 1.87548 13.305 -2.22526 -24.419 13.8486 +100 1 8.37947 10.1962 1.80259 -4.93469 16.4683 -10.3397 +101 2 8.22749 10.8872 2.46356 1.16914 -1.49574 -1.6966 +102 2 8.71062 9.47199 2.30942 8.47484 -21.3721 12.0127 +103 1 10.3811 1.71408 15.5377 20.686 0.359172 -10.6925 +104 2 11.354 1.66546 15.4316 -15.8773 -5.06945 10.6173 +105 2 10.0964 2.02238 14.6685 -5.35844 0.742925 -2.36882 +106 1 2.68357 12.8347 7.81396 4.59418 8.51704 7.17464 +107 2 3.18489 13.5948 7.4697 -3.72618 -6.19027 -0.541735 +108 2 1.90686 12.7457 7.24856 2.42229 -2.05385 -5.50174 +109 1 3.74169 11.6981 5.12659 20.4064 16.2552 5.07347 +110 2 3.6031 10.8525 5.51837 -2.34348 -17.0347 14.1119 +111 2 3.05756 11.7956 4.48632 -17.1397 4.43934 -14.0111 +112 1 6.78306 14.4202 16.945 8.30127 18.455 -2.7408 +113 2 7.70256 14.7228 17.0235 -7.00262 -4.27134 -0.857039 +114 2 6.4289 14.8468 16.1479 2.30915 -9.19793 -2.69046 +115 1 14.2185 14.5268 3.31588 -23.2154 9.18115 10.9982 +116 2 13.6682 15.2954 3.06852 12.5657 -5.26706 1.63848 +117 2 13.7604 14.1667 4.10581 9.83524 -2.33371 -14.8176 +118 1 8.44676 18.1227 16.0393 7.73472 16.3177 -1.68025 +119 2 9.01165 17.3799 16.1525 3.2644 -34.6246 10.2309 +120 2 9.11477 0.14931 15.8801 -4.9724 20.6673 -2.43491 +121 1 4.70679 1.64341 4.91058 -17.3364 -32.3489 41.2122 +122 2 3.86106 2.04855 5.10849 -6.14561 5.35271 -2.51022 +123 2 5.03045 2.1011 4.1778 23.045 28.1017 -39.82 +124 1 14.9769 12.6712 16.4491 28.5182 -25.5733 -37.1858 +125 2 14.5585 13.1664 17.1249 -24.0861 16.0366 17.7329 +126 2 14.4092 12.4828 15.6576 3.30334 14.0855 25.2157 +127 1 15.7195 18.4537 16.8862 -41.4911 -4.79998 -47.5194 +128 2 16.474 18.4695 17.416 41.6971 -5.3201 37.0536 +129 2 15.5173 17.5216 16.6763 -0.165283 4.31671 10.9236 +130 1 1.26675 1.20722 16.5821 1.91531 -3.73727 -7.96899 +131 2 2.06576 1.68562 16.7995 9.77153 8.32265 -0.296149 +132 2 0.695796 1.45596 17.2985 -12.9769 2.74169 12.7471 +133 1 18.1595 4.46894 15.9392 -8.68238 9.49864 15.6389 +134 2 18.21 4.01948 15.1094 2.12602 -9.4702 -15.5502 +135 2 0.321646 4.30297 16.4236 6.52219 -0.344151 0.382064 +136 1 12.2433 16.9631 16.1365 30.1535 25.9085 -42.0202 +137 2 11.4764 16.7912 16.6244 -43.4812 -17.6238 21.6018 +138 2 11.9609 17.1491 15.2014 5.35486 -10.4534 20.1012 +139 1 16.0404 2.55502 18.1172 12.6912 -10.4842 9.42679 +140 2 15.6589 3.39683 18.3503 -6.59057 14.1496 4.33812 +141 2 15.9441 2.46009 17.1755 -7.16214 2.08136 -15.1428 +142 1 6.70635 13.8458 10.192 -16.5385 -19.5662 -16.6234 +143 2 6.46743 13.4829 11.0519 3.62966 4.37567 6.36784 +144 2 6.41781 13.1513 9.56037 11.5929 10.5707 5.5488 +145 1 10.1419 18.3987 2.73425 -19.4638 -25.4286 12.0097 +146 2 10.2073 0.494584 2.15475 6.00155 18.7458 -18.7245 +147 2 9.2799 18.0069 2.48337 13.6051 6.39322 6.25061 +148 1 3.04438 17.7185 6.11283 5.61436 7.93422 -10.0091 +149 2 2.18521 17.5434 5.71014 -2.22655 1.93918 -4.29169 +150 2 3.60431 18.0006 5.35738 -6.06642 -9.44159 14.8188 +151 1 12.59 16.8727 7.99688 3.41749 0.26688 0.968442 +152 2 11.9163 16.1959 7.96054 -9.29683 -10.0995 -8.1817 +153 2 12.3648 17.371 8.78825 5.01363 9.11979 0.25951 +154 1 14.8925 15.2941 8.21002 11.8118 0.190541 -21.4145 +155 2 14.0466 15.7377 8.15471 -7.99071 7.70949 7.81769 +156 2 15.2804 15.4945 7.32486 -0.0803457 -7.85257 22.8773 +157 1 17.7158 18.2428 0.330134 42.1686 22.2301 9.80157 +158 2 18.5718 17.7519 0.320787 -20.6577 0.0591745 -9.59458 +159 2 18.0296 0.514827 0.540707 -19.3386 -19.3229 -5.27308 +160 1 0.848087 10.4587 1.36302 27.1846 51.9138 -28.6855 +161 2 0.125428 9.973 1.66463 -44.0007 -34.6793 17.9508 +162 2 0.450253 11.2027 0.827225 17.544 -22.8417 14.6566 +163 1 1.73752 12.2317 3.35921 -10.6222 -3.23772 -40.3174 +164 2 1.50468 11.5771 2.65039 3.80547 3.73659 24.0112 +165 2 1.78112 13.0447 2.82871 4.93945 -0.670418 11.0651 +166 1 0.61763 17.2312 4.89977 -31.3278 9.09129 49.7394 +167 2 18.753 18.067 4.93438 12.2337 -8.61092 -13.4292 +168 2 0.309388 16.8063 5.75223 19.8395 0.744545 -34.548 +169 1 1.12081 0.925337 9.40389 -12.5044 -10.6635 0.652446 +170 2 1.34187 0.581545 10.2981 -6.32089 4.74016 -12.6461 +171 2 0.253358 0.524348 9.17819 18.5788 9.22491 5.8567 +172 1 16.7331 2.36195 13.2995 -4.07693 -18.6231 24.2357 +173 2 16.9587 2.56306 12.4093 5.05193 8.99127 -27.3142 +174 2 16.5121 1.41005 13.3069 2.86591 9.33714 2.00751 +175 1 2.6752 15.8404 12.084 -17.9655 13.8891 -13.7444 +176 2 3.1007 15.4046 12.7977 10.8605 -10.5552 20.9848 +177 2 3.18035 15.6022 11.2985 0.61387 1.79975 -2.62876 +178 1 16.4324 15.6688 6.07894 -11.0906 -29.1832 8.11987 +179 2 17.3135 15.6699 6.4691 2.82688 3.86386 -3.5648 +180 2 16.3493 16.3586 5.42897 4.86465 16.2346 -9.8305 +181 1 5.78229 5.11191 11.8099 -13.8406 10.2937 3.29755 +182 2 5.26053 5.84491 12.2174 12.8802 -11.8636 -2.84442 +183 2 5.17337 4.36282 11.7377 2.58239 3.92087 3.15374 +184 1 15.1463 4.86734 0.794152 0.864651 12.4924 -33.9562 +185 2 14.9842 4.50309 1.65022 -3.17819 -5.74322 26.2661 +186 2 14.3662 5.39647 0.571272 5.91156 -4.56503 2.45287 +187 1 16.3343 16.3902 2.05204 -8.53913 3.9795 31.3204 +188 2 16.0972 16.7844 2.93864 3.99019 -13.2916 -26.145 +189 2 16.6713 17.1379 1.5654 4.18336 9.27065 -12.2854 +190 1 0.251768 4.84384 3.8243 -5.07672 -49.1083 -0.618349 +191 2 0.303365 5.75864 3.98841 7.12191 44.1717 7.46524 +192 2 0.849427 4.39339 4.43966 -1.76195 8.48948 -7.42491 +193 1 2.97026 15.0637 15.1648 0.961584 14.1925 -19.6325 +194 2 2.86359 14.8338 16.0871 -5.01806 -10.0022 10.5852 +195 2 2.57214 15.9549 15.1104 2.70735 -9.48442 0.706884 +196 1 1.14871 14.6442 9.53518 -42.8529 -19.211 3.24989 +197 2 2.06628 14.849 9.52706 28.3433 -3.949 4.37311 +198 2 1.01023 13.7361 9.90627 12.772 19.4662 -8.86837 +199 1 13.5229 16.5669 11.532 20.3549 -23.4698 16.7524 +200 2 13.3606 17.2446 10.8944 -12.6142 15.9017 -14.8664 +201 2 13.2357 15.729 11.1267 -5.06335 10.0173 1.96475 +202 1 4.64907 1.44855 0.782556 14.1843 16.2277 -15.4645 +203 2 4.13811 2.00007 0.175187 -1.198 1.13782 0.731863 +204 2 4.05002 0.760268 1.05534 -6.36237 -9.04178 10.9284 +205 1 1.45269 18.5669 11.8512 9.08594 -18.5638 20.5671 +206 2 1.3209 0.513151 12.6112 1.192 -1.45307 -0.682323 +207 2 1.82538 17.7349 12.2384 -6.22294 17.2853 -13.4176 +208 1 11.5083 10.14 3.99231 -12.3356 -6.67004 24.2683 +209 2 11.3008 10.4626 3.12291 -1.30093 6.41155 -12.7666 +210 2 12.4624 10.1697 4.04844 12.7044 -2.53047 3.95194 +211 1 8.22637 12.1595 3.70182 22.1984 -6.43536 -24.1249 +212 2 9.06359 12.543 3.994 2.39995 3.52197 1.898 +213 2 7.64229 12.2644 4.4292 -22.7553 4.87752 31.4773 +214 1 14.5041 4.04055 3.28708 -18.3332 1.47774 -0.327682 +215 2 14.9873 3.94029 4.11097 10.9182 2.80533 4.02706 +216 2 13.7169 4.55783 3.53097 2.05743 -3.46177 -0.871318 +217 1 5.62743 1.64825 7.52429 33.006 28.3977 -54.9531 +218 2 5.01294 1.12929 7.98513 -35.2623 -28.0367 23.7041 +219 2 5.43705 1.49837 6.5464 4.70081 6.15592 32.4881 +220 1 17.8649 1.10253 4.84999 -3.85271 -3.04411 9.89583 +221 2 18.5316 1.48406 4.28754 10.0589 0.579138 -13.4652 +222 2 17.9089 1.63153 5.65146 -2.44801 0.268727 5.2117 +223 1 6.82865 9.41118 4.50161 13.9732 -1.80028 18.7676 +224 2 6.94383 9.68391 5.43824 -8.65407 -5.40133 -16.2957 +225 2 7.70845 9.07477 4.25578 -5.27921 1.965 -0.840285 +226 1 2.66065 14.8943 1.98186 -2.57221 -9.24308 25.7982 +227 2 3.31586 14.7955 2.69868 -8.68087 -2.61777 -7.29774 +228 2 3.12007 15.367 1.30687 7.03004 7.53846 -18.6884 +229 1 17.3318 12.9277 13.2024 14.566 -8.41998 -6.98679 +230 2 16.4646 13.2932 13.3909 -3.11164 10.4066 0.365823 +231 2 17.9245 13.6681 12.9725 -15.6789 -3.68206 1.74475 +232 1 14.9332 10.5631 1.42248 26.9386 23.5346 15.1493 +233 2 15.5074 11.3103 1.7869 -22.4798 -24.8917 -12.2482 +234 2 14.0193 10.8096 1.5708 -2.19259 1.9486 -0.294463 +235 1 5.71089 6.73608 4.5629 -4.22281 28.118 -3.03355 +236 2 5.94827 7.69445 4.64343 -4.82413 -18.183 -7.3163 +237 2 6.31292 6.28304 5.16113 4.14578 -2.25186 0.1588 +238 1 7.97883 8.3192 10.3001 7.8407 -5.86676 -34.7961 +239 2 8.53275 9.01778 9.91692 4.61581 1.53144 9.76809 +240 2 7.67805 7.86001 9.48783 -4.88471 -0.599295 18.8237 +241 1 13.4226 18.4487 5.72909 4.08913 1.21656 -6.98532 +242 2 12.585 0.250804 5.52036 7.76092 4.80861 -0.84516 +243 2 13.2097 17.9386 6.50687 -2.642 -10.6174 11.5339 +244 1 0.0869602 2.62265 0.223952 -9.8031 -15.3274 -6.51765 +245 2 17.9117 2.88521 18.4333 -9.97249 -6.92357 5.22107 +246 2 0.604672 3.41479 0.198655 20.2406 16.0872 6.75582 +247 1 12.7806 11.0275 9.75202 47.836 -29.2198 23.6504 +248 2 11.892 10.9606 9.4924 -44.5823 -3.62186 -10.7645 +249 2 12.9839 10.1194 10.1272 -4.83434 23.2951 -13.1663 +250 1 0.705171 12.1501 11.0469 -11.5221 2.5881 -10.739 +251 2 18.3743 12.1368 11.1638 13.8029 4.27958 5.25964 +252 2 1.13401 12.4861 11.8379 -3.00537 2.27024 12.2218 +253 1 5.1174 7.31342 13.4172 11.1181 3.69095 0.765545 +254 2 5.61979 7.99643 12.9358 -2.94992 -2.73128 4.30069 +255 2 5.6521 7.15272 14.218 -5.77355 -1.15348 -7.33249 +256 1 1.197 6.86571 11.8595 38.3077 26.916 14.5555 +257 2 0.451078 7.27927 11.4324 -8.7071 4.85333 -5.01967 +258 2 1.83731 7.62187 12.0983 -31.0022 -32.2106 -6.42275 +259 1 15.4885 9.63727 12.3206 16.478 -29.8614 -10.1392 +260 2 15.1661 10.5006 12.1398 -12.0715 29.4427 -0.903292 +261 2 15.2587 9.41843 13.2151 -2.74274 1.51694 14.7591 +262 1 16.5678 12.6919 5.49509 2.68502 5.28083 21.2685 +263 2 16.324 13.6184 5.59953 -0.326156 6.48336 2.9395 +264 2 16.4016 12.5196 4.57887 -2.84479 -5.20052 -25.0662 +265 1 6.28213 9.87258 0.0490999 16.8985 1.83912 15.6964 +266 2 5.56262 10.3905 0.421328 -3.89363 2.12479 6.12138 +267 2 7.01982 9.90555 0.722608 -19.7924 2.8001 -17.1777 +268 1 12.2865 6.1036 4.06304 19.2748 24.5544 -29.5048 +269 2 12.3306 6.8161 3.36437 1.4085 -17.3408 22.8012 +270 2 11.3814 5.83426 4.0192 -21.2841 -11.2083 4.33393 +271 1 0.298047 12.7955 0.166375 -3.43648 3.64279 0.0778505 +272 2 -0.0290314 13.4316 0.817326 3.1389 2.62115 2.93426 +273 2 18.4391 12.9788 18.0124 -4.25126 3.67416 -7.60949 +274 1 3.647 18.6117 8.59889 -15.5834 11.8668 6.1299 +275 2 3.50703 18.267 7.70639 0.18727 -3.89186 2.0216 +276 2 2.76186 0.338497 8.83167 17.7751 -6.65964 -2.12733 +277 1 7.50606 17.376 4.49824 -10.0508 -46.4512 11.7168 +278 2 7.49016 18.3059 4.51667 7.03352 43.591 -0.815572 +279 2 7.72157 17.1186 3.60818 -1.05523 3.68228 -12.2984 +280 1 9.25162 17.1195 12.2401 -20.7119 -1.17481 -13.1138 +281 2 9.34873 16.3083 11.723 0.965197 -1.09758 -0.258815 +282 2 10.0653 17.2534 12.7074 19.1017 -2.42392 11.5163 +283 1 13.35 12.9891 7.98546 26.3101 20.7404 -8.62941 +284 2 13.4089 12.1901 8.49273 -4.66259 -15.0904 10.7497 +285 2 14.2093 13.4501 8.17144 -24.2961 -0.252284 -5.87391 +286 1 14.9018 2.99422 15.3537 -18.6075 -8.06583 14.6174 +287 2 14.2375 2.30647 15.2045 2.81445 1.4476 3.5012 +288 2 15.4631 2.94521 14.5905 14.0528 3.89371 -13.7736 +289 1 9.86333 15.5824 16.9775 -1.70109 -0.0675876 9.27141 +290 2 10.3396 14.7637 16.7526 0.856458 3.65656 -1.57854 +291 2 9.55317 15.4797 17.8978 1.12056 -0.962034 -11.839 +292 1 11.2957 8.40029 16.577 -16.0633 -20.1101 7.86553 +293 2 10.6817 7.8482 16.0424 7.68237 12.4971 4.88138 +294 2 11.3251 7.92133 17.4322 4.78934 8.39937 -13.6138 +295 1 3.89281 18.1695 16.7848 -3.14598 -18.8551 -14.8366 +296 2 4.41813 17.5168 17.2844 -2.97968 13.5676 2.86087 +297 2 3.87713 0.360621 17.2331 6.32956 9.89438 13.0847 +298 1 2.18947 4.17934 8.91366 -18.0693 4.35017 -17.8699 +299 2 3.09766 4.08917 8.6846 23.1764 -2.78898 -7.58361 +300 2 2.16493 4.06394 9.84833 -5.05649 -4.17918 28.8808 +301 1 9.87375 10.372 9.69798 10.3489 -25.1121 17.1783 +302 2 9.47622 11.1704 9.40878 -10.9495 28.2307 -13.2887 +303 2 10.0218 10.4724 10.6474 2.61027 -3.39635 1.23761 +304 1 9.66501 0.904023 10.8717 -13.0386 -22.5074 -9.87351 +305 2 9.3051 0.0213231 11.0865 8.01248 8.88818 8.11202 +306 2 9.06191 1.19139 10.169 9.00305 9.82525 0.172013 +307 1 9.18563 15.0903 10.2115 17.1556 13.6164 1.72702 +308 2 8.73275 15.8289 9.78742 -0.477718 6.62954 -2.89772 +309 2 8.53792 14.3995 10.1946 -15.8858 -12.7719 2.13472 +310 1 0.946133 9.58267 10.2797 -17.999 7.07835 7.04569 +311 2 0.977457 10.4775 10.6382 -6.96742 -0.068666 -4.76802 +312 2 1.85682 9.38261 10.1843 21.4216 -13.3352 -8.00245 +313 1 16.9414 4.83421 8.13223 15.4014 12.0295 -27.8426 +314 2 16.4342 5.57084 8.44793 -11.0978 12.5109 2.31217 +315 2 16.8158 4.17203 8.77314 -2.49922 -25.6846 24.7871 +316 1 14.7535 14.7061 0.203986 15.073 4.98951 -2.11802 +317 2 15.1043 15.2916 0.890887 3.3452 -1.27018 2.88153 +318 2 13.9621 14.3164 0.552408 -18.4772 -7.94901 9.40987 +319 1 3.67958 11.0243 9.53991 2.98139 -0.929731 17.0732 +320 2 3.55398 11.294 10.4695 5.20942 3.18167 -4.3207 +321 2 3.23108 11.6955 9.00414 -3.72853 0.365488 -5.84942 +322 1 11.2021 10.759 1.44219 -17.3262 -13.0718 -7.65614 +323 2 11.58 11.5828 1.16251 10.55 19.7497 -9.01804 +324 2 10.309 10.7579 1.05212 6.07305 -2.69648 6.21388 +325 1 13.1662 7.17502 12.7531 25.9391 -3.29657 1.887 +326 2 14.1362 6.96154 12.7671 -19.0435 5.16748 0.470499 +327 2 12.7272 6.32599 12.8606 -4.03684 -6.30893 0.442018 +328 1 9.61497 1.86018 0.978015 -9.58691 9.0933 -29.7593 +329 2 8.82052 1.59363 0.443821 14.7013 3.9795 16.3864 +330 2 10.1598 2.41617 0.376969 -4.12787 -12.2318 8.97473 +331 1 10.6544 13.5231 4.58863 -13.6132 -6.73185 -2.44549 +332 2 11.4017 12.9559 4.77554 12.969 -5.04099 -4.5155 +333 2 10.624 14.0848 5.36102 -2.93668 8.13722 11.8558 +334 1 14.451 1.77042 10.9566 -5.06993 -21.3108 1.92478 +335 2 15.2282 1.34301 10.5576 -2.05514 6.77792 0.416034 +336 2 14.5487 2.7176 10.8324 3.84606 4.21375 0.609558 +337 1 14.5616 12.2019 11.6619 17.6804 1.81894 22.1071 +338 2 15.3038 12.427 11.1092 19.6924 5.46932 -2.69443 +339 2 13.8862 12.1117 11.0284 -35.3643 -9.54852 -21.0379 +340 1 8.20666 5.07147 9.84086 19.0973 -30.0877 -21.2342 +341 2 7.45963 5.1784 10.3955 -25.2729 10.7477 18.5337 +342 2 8.15765 4.10536 9.6198 7.47394 24.0469 -0.436218 +343 1 1.5637 16.9015 18.3956 -12.4387 -25.8837 12.5929 +344 2 2.10927 17.2609 17.7108 10.7809 10.3745 -20.1818 +345 2 1.47705 15.9462 18.1578 7.28008 19.3441 8.23831 +346 1 1.51254 17.2865 15.33 -55.1424 19.1245 13.5119 +347 2 1.44158 18.2256 15.6397 11.4216 -23.3977 -5.64032 +348 2 0.55797 16.9673 15.4072 37.0312 4.44622 -8.61518 +349 1 3.63692 5.75726 6.07961 7.7365 -18.3794 -8.43759 +350 2 3.1745 6.31944 6.69962 -9.61621 11.1355 4.40451 +351 2 4.08899 6.28836 5.40075 -0.121738 1.87808 9.22135 +352 1 12.4625 9.47055 14.2033 -9.88788 31.7301 7.89028 +353 2 12.9131 8.72585 13.8435 10.9703 -26.4307 -11.7769 +354 2 12.2412 9.2145 15.1039 -0.841012 -4.82452 5.58465 +355 1 4.05279 15.2823 6.91192 -35.0907 -10.5097 14.3913 +356 2 3.49702 16.0377 6.67476 5.8423 0.670453 -1.17602 +357 2 4.92638 15.5321 6.67665 32.7349 8.37925 -5.72993 +358 1 0.666426 8.62945 15.01 -4.81633 6.31993 2.8284 +359 2 0.390025 9.55783 15.0778 2.6081 -0.187855 1.05312 +360 2 1.36445 8.64555 14.3512 6.1817 -1.74341 -6.99991 +361 1 12.9834 8.27358 10.2916 -19.5051 6.59204 10.6567 +362 2 13.6375 7.73399 9.85191 12.7638 -5.94229 -3.5145 +363 2 12.8815 7.86968 11.1799 4.96282 8.38227 -11.7258 +364 1 15.3269 7.75333 3.56288 29.5219 38.2257 -22.8776 +365 2 14.5855 7.35684 3.13467 -21.9298 -17.371 4.59449 +366 2 15.5403 7.50003 4.45743 -10.8574 -16.6026 13.017 +367 1 17.2887 6.69393 0.021468 15.5778 -19.6292 8.74644 +368 2 16.7574 5.92192 0.248673 1.14134 -1.83764 1.32773 +369 2 16.6558 7.32534 18.3698 -22.9594 20.3863 -6.57681 +370 1 8.86981 6.94597 7.81474 24.2415 27.8548 -9.55577 +371 2 9.77577 7.36617 7.90295 -24.2622 -15.8521 -2.69303 +372 2 8.7837 6.29392 8.50186 -0.35036 -13.7271 19.3897 +373 1 12.3819 0.576227 1.23609 4.50683 -3.19553 -2.96149 +374 2 13.3476 0.534404 1.26268 -2.04299 5.45052 6.49319 +375 2 12.129 0.50298 0.316799 -1.00379 -2.5807 -2.54403 +376 1 5.62478 15.1294 14.5559 -8.95515 -20.8805 6.21096 +377 2 4.66749 15.251 14.733 11.0075 0.339747 -2.61971 +378 2 5.99586 15.9305 14.1948 2.79164 18.0184 -3.26028 +379 1 3.86891 6.41255 1.75203 -0.0773217 -5.81596 13.5476 +380 2 3.55695 7.28194 1.50076 -6.60469 12.2107 -8.14743 +381 2 4.09127 6.52195 2.68979 -0.816275 -1.80663 -6.76426 +382 1 3.9342 11.5843 12.3776 -18.6931 -4.72392 -0.912594 +383 2 4.79227 12.0122 12.4616 2.30575 0.246561 2.78418 +384 2 3.29871 12.1178 12.8946 9.72132 -5.51488 -9.32366 +385 1 5.32882 3.8676 15.8786 0.594801 -80.2026 -15.123 +386 2 6.00417 3.18473 15.5574 -21.0433 25.388 14.8589 +387 2 5.72544 4.69544 15.8213 26.1638 51.9163 -2.72297 +388 1 14.3304 10.2034 4.48175 -27.4096 24.8129 53.7077 +389 2 14.5884 9.79586 5.33863 -8.33179 4.59428 -12.4543 +390 2 14.8538 9.80174 3.84099 29.6706 -27.6476 -38.9945 +391 1 7.77951 17.4021 9.16969 8.83259 -7.31352 -4.45478 +392 2 6.90706 17.6601 9.4324 -15.0276 -0.0996042 12.8709 +393 2 7.95009 17.9588 8.40488 9.49987 1.3194 -6.72214 +394 1 4.51552 14.5162 3.99356 4.98181 -4.90212 -22.3913 +395 2 4.52626 15.4247 4.27156 -0.518589 17.7617 2.00307 +396 2 4.31207 14.0204 4.77138 -3.57212 -17.3619 18.7252 +397 1 14.1875 7.4375 15.7998 -22.901 -10.8896 -16.0938 +398 2 15.1146 7.35808 15.6286 24.9688 -1.25651 -4.60954 +399 2 14.1131 7.89225 16.6248 1.32628 8.65776 19.0596 +400 1 2.98527 18.3068 1.9119 -4.72699 -30.9822 -37.1172 +401 2 2.49826 17.7826 1.20191 12.7581 13.6458 27.4428 +402 2 2.34371 0.225349 2.32895 -15.9948 14.8465 9.72817 +403 1 8.01181 1.59883 4.56348 -29.7821 5.07108 -10.5683 +404 2 7.46781 2.03632 3.88017 -2.37558 -3.45248 10.775 +405 2 8.87859 1.65459 4.20584 24.9106 -1.40589 -4.13938 +406 1 2.43696 14.1424 17.6778 32.6678 8.55365 0.150748 +407 2 1.74447 13.6484 18.0869 -17.757 -15.5673 8.49591 +408 2 3.25626 13.7213 18.0204 -5.64692 6.54589 -2.94203 +409 1 0.856601 1.76819 13.8909 -34.0133 7.6587 12.0684 +410 2 0.79549 1.64555 14.8654 10.1884 -1.39389 -18.6264 +411 2 18.5699 1.97567 13.6249 24.5068 -3.80874 6.24474 +412 1 4.3972 0.0813689 13.9033 -13.8751 0.78744 16.7708 +413 2 5.2251 18.2898 13.7459 20.8939 -4.75733 -3.28132 +414 2 4.21678 18.5292 14.8441 -3.95615 2.50922 -10.6456 +415 1 7.163 0.723926 18.3524 28.8431 -20.8152 -22.3389 +416 2 7.29578 0.265373 17.4701 -6.89821 16.5948 25.8874 +417 2 6.28988 1.09447 18.4079 -18.4483 2.86302 0.00697782 +418 1 16.0461 18.4126 13.9592 23.9709 4.87143 24.0859 +419 2 15.127 18.3862 13.8391 -39.1169 -4.38354 -15.9017 +420 2 16.1011 18.5404 14.9193 8.5862 0.360016 -3.75437 +421 1 10.1416 4.5234 16.2814 33.6533 37.5162 -8.59515 +422 2 11.1148 4.69187 16.0483 -33.0569 -13.9639 15.4314 +423 2 9.96481 3.59397 16.253 2.9151 -23.0089 -4.34536 +424 1 15.9284 17.7644 4.42623 32.451 -11.9188 -9.4973 +425 2 16.5348 -0.134683 4.55752 -3.00893 1.73986 -2.0661 +426 2 15.0985 18.0471 4.75447 -36.3204 13.6328 11.8833 +427 1 7.01478 17.4412 13.8546 -37.2955 -8.85564 -21.6385 +428 2 7.52749 17.7553 14.5758 15.4879 9.12118 24.9138 +429 2 7.64547 17.2338 13.1683 11.7367 1.38126 -7.54157 +430 1 13.2517 6.48941 6.59541 21.6379 18.6409 -4.45059 +431 2 14.0732 7.02646 6.4901 -17.572 -15.5204 8.29538 +432 2 12.9904 6.33391 5.6816 -8.39128 -3.46546 0.217322 +433 1 7.82903 2.34082 9.30706 0.848413 1.46751 38.8479 +434 2 7.32489 2.17899 10.1397 9.78087 5.93227 -12.3925 +435 2 7.21411 2.12937 8.62642 -15.7826 -8.09866 -24.9258 +436 1 15.1931 14.7992 13.6996 5.60594 -14.9485 0.236255 +437 2 14.8724 15.0774 14.5533 -1.16755 2.2837 13.7936 +438 2 15.0044 15.5062 13.0994 -6.5851 10.7381 -11.5383 +439 1 9.39722 8.31385 3.80437 -4.07127 17.2834 -4.44624 +440 2 10.2713 8.68973 4.00761 -3.0526 -2.08627 -0.470344 +441 2 9.46128 7.36215 3.86627 5.27028 -8.92187 3.93672 +442 1 17.7859 13.5845 16.3834 -19.0466 -29.0207 18.2461 +443 2 16.8295 13.3731 16.3512 7.31415 3.8698 0.00611806 +444 2 17.8697 14.4051 15.917 1.12921 18.7325 -11.1152 +445 1 4.94376 10.5922 2.82245 -18.0715 22.8685 -14.9529 +446 2 5.66076 10.3167 3.37377 16.0421 -11.7082 13.1735 +447 2 4.72943 11.4907 3.12728 0.871258 -13.2337 -1.99455 +448 1 3.75648 8.36099 10.0882 -2.83158 17.8244 -9.78689 +449 2 3.88314 9.30809 9.8443 -3.15161 -16.2727 -0.870444 +450 2 3.74879 8.36585 11.0419 0.849549 -1.60464 13.0402 +451 1 15.9818 6.99244 6.07768 -13.3688 18.7296 1.03973 +452 2 16.7792 7.41732 6.38792 13.9106 3.61693 3.9934 +453 2 16.2026 6.08994 5.88298 6.53831 -20.9898 -2.75314 +454 1 15.1161 7.11481 9.04764 0.565665 -31.7989 38.5144 +455 2 15.8028 7.45918 9.62834 5.57768 4.61323 -0.34974 +456 2 15.1416 7.62578 8.27782 1.5606 28.4329 -39.6698 +457 1 6.26636 12.9592 12.746 15.2088 -10.2167 -2.30532 +458 2 7.09456 12.5046 12.9751 -5.12301 -5.10662 -0.512627 +459 2 6.13107 13.5604 13.4742 -6.25916 17.1748 9.55337 +460 1 12.1295 4.51914 13.098 -40.0586 -31.7334 -0.542355 +461 2 12.3128 4.55827 14.0372 7.66008 7.87672 6.17129 +462 2 11.3118 3.91999 13.0515 32.2373 26.2449 -7.62055 +463 1 11.3854 8.14886 7.92202 -18.4022 6.94815 -10.6415 +464 2 11.9487 7.53516 7.44565 12.5498 -6.92106 -4.31871 +465 2 11.7891 8.26504 8.77918 7.07043 -0.608458 13.7447 +466 1 17.1486 10.8722 7.52372 -29.3422 15.2924 19.4167 +467 2 17.741 10.1746 7.28593 21.144 -15.6164 -13.9006 +468 2 16.9754 11.4691 6.78151 4.60435 -5.53137 -7.06809 +469 1 5.26553 18.1239 10.9774 20.3802 -2.13667 -3.01104 +470 2 4.75345 17.8709 11.7323 -12.4512 -5.88679 12.7575 +471 2 4.64325 18.2391 10.2688 -13.5246 2.23536 -17.92 +472 1 7.60715 17.4884 1.7834 -2.49749 -8.82149 -34.1915 +473 2 7.92668 16.7242 1.2322 -11.5566 19.54 16.0619 +474 2 7.18999 18.106 1.13139 15.7932 -7.79309 14.6318 +475 1 1.92845 12.8983 13.5911 -4.1829 -6.61346 -8.43532 +476 2 1.49445 12.3761 14.2737 -4.42561 -3.96966 1.7572 +477 2 2.30088 13.6477 14.0465 3.83448 15.9215 12.3791 +478 1 9.57624 6.80131 14.8487 2.82943 -31.3701 -0.177857 +479 2 9.74438 5.86263 15.1368 -4.04832 25.5486 -0.431769 +480 2 9.80341 6.81631 13.907 0.113844 6.0265 -0.426062 +481 1 15.2789 4.31862 10.7553 12.937 12.8557 31.6205 +482 2 16.1415 3.96953 11.0436 -5.39931 0.983411 -21.2391 +483 2 15.1479 4.98349 11.4601 -8.5537 -3.88808 -14.9921 +484 1 11.2581 6.18474 0.159508 31.1076 25.8623 9.85053 +485 2 11.549 5.31982 18.5294 -8.46095 -20.0483 -6.31791 +486 2 10.3153 6.29854 0.132928 -17.8901 -6.88616 -7.00405 +487 1 -0.015613 11.3989 15.0155 5.52071 0.0143375 15.3818 +488 2 18.1286 11.6803 14.2478 -6.84029 3.18322 -8.47428 +489 2 -0.24984 12.0811 15.6717 7.42423 -4.02873 -7.86488 +490 1 7.04792 9.26093 7.28081 24.8295 12.5521 -3.74072 +491 2 6.59027 8.49663 7.6071 -13.7147 -18.0719 7.78469 +492 2 7.98742 9.01504 7.31689 -8.33941 1.9664 -1.88331 +493 1 18.3308 15.3469 12.3202 -6.03602 -2.26652 6.8961 +494 2 0.60478 15.4762 12.0772 12.6515 4.5696 -6.24084 +495 2 17.7927 15.7945 11.6538 0.941578 1.81095 -5.33876 +496 1 16.5149 4.38922 5.26132 -0.591505 19.7601 -54.4807 +497 2 16.8056 3.98806 6.0517 15.8153 -15.5532 32.6352 +498 2 17.2724 4.45951 4.61195 -16.46 -3.71476 24.2381 +499 1 17.705 3.15738 10.7395 -3.58994 -28.0349 -4.43916 +500 2 -0.0357658 3.31586 11.0143 13.799 7.93723 3.46651 +501 2 17.7252 2.25587 10.3433 -5.09014 14.337 3.42017 +502 1 12.282 -0.0102014 10.1171 1.80463 -26.6374 -6.99772 +503 2 11.3739 0.250254 10.2263 -16.4794 9.03176 6.86793 +504 2 12.791 0.759276 10.3145 17.2573 22.9944 3.87451 +505 1 10.3906 9.77529 12.4736 -11.6246 -18.6488 -11.2601 +506 2 11.1162 9.76462 13.0993 9.33947 3.77576 6.26492 +507 2 10.2448 8.81959 12.3007 0.540403 13.8663 1.27912 +508 1 0.620737 2.80838 7.04076 1.85552 -26.9198 -9.07562 +509 2 0.56001 3.58776 7.58035 -0.0658531 10.9425 14.6075 +510 2 1.10446 2.13014 7.5549 -9.15748 13.0523 1.42789 +511 1 0.330306 15.2957 6.90187 -7.34135 39.0889 57.248 +512 2 0.64916 14.9551 7.78023 -6.58887 6.78122 -17.5325 +513 2 0.549392 14.6745 6.26262 18.9985 -47.7984 -33.3782 +514 1 17.0475 6.9988 15.1595 3.61332 2.27156 3.35689 +515 2 17.7695 7.63103 15.0486 -1.58895 3.22527 -3.41358 +516 2 17.4554 6.32111 15.7084 -3.97121 -9.30147 -1.03946 +517 1 9.1229 12.4841 8.04245 42.4716 -17.0961 -6.2748 +518 2 9.3803 11.751 7.44403 8.89783 14.9312 6.88846 +519 2 8.20686 12.4452 7.97952 -55.5673 6.80073 1.54221 +520 1 1.25348 1.79037 2.92813 -6.45569 8.99744 5.64127 +521 2 0.618969 2.05555 2.26044 -0.811293 0.804254 -10.1384 +522 2 1.53437 2.62736 3.32834 8.32683 -8.65344 1.50874 +523 1 4.08283 15.132 9.84955 18.6585 -7.67887 -4.13383 +524 2 4.13303 15.3467 8.91064 -4.64689 1.73023 -5.13685 +525 2 4.95775 14.7288 10.0227 -10.2431 6.10486 1.39562 +526 1 7.30601 2.19422 14.6517 -6.95706 -8.0865 3.71032 +527 2 7.17746 1.61632 13.8834 -0.940722 6.01065 3.73041 +528 2 7.50104 3.06853 14.3169 9.18921 6.42869 -7.97623 +529 1 18.506 14.6308 2.17255 -30.1365 -0.614545 -1.61255 +530 2 0.727688 15.0378 2.26332 7.05 8.92743 1.17189 +531 2 17.7886 15.3173 2.20949 19.3309 -8.24877 -2.15246 +532 1 9.97566 2.72581 12.9114 -11.2099 12.673 12.9937 +533 2 9.86165 2.06107 12.2382 3.86591 -12.7401 -14.4562 +534 2 9.16654 3.26167 12.8314 9.11555 0.77907 4.27596 +535 1 2.93178 8.92582 13.081 1.70152 2.66119 1.53014 +536 2 3.14805 9.86555 12.9479 4.31652 -6.20308 -1.56758 +537 2 3.73073 8.51399 13.4597 -8.92719 0.122715 -5.32652 +538 1 3.2497 8.49808 3.73135 7.7637 26.6897 -66.399 +539 2 3.59457 9.35475 3.3251 -8.07179 -35.8245 7.88572 +540 2 3.32757 8.66083 4.63283 0.688531 4.50937 55.9505 +541 1 5.66796 7.21231 8.59238 -0.641232 -8.3741 -2.33168 +542 2 5.55885 6.25431 8.52804 10.6614 2.37054 -1.78385 +543 2 4.98671 7.4468 9.22816 0.961703 9.61661 1.51464 +544 1 14.8738 1.42122 1.93778 -12.939 -8.09002 14.9013 +545 2 14.5066 2.19936 2.41013 13.5309 -5.26917 -12.7438 +546 2 15.3961 1.64306 1.16722 2.80937 13.5796 -4.98575 +547 1 8.4154 15.1394 0.773463 -1.23857 3.93157 -9.75401 +548 2 9.15191 15.1483 1.39458 4.79594 -7.97678 6.77178 +549 2 7.72939 14.5584 1.13871 1.01453 -0.106788 3.48853 +550 1 15.5631 1.364 7.19799 20.5383 14.1474 18.9399 +551 2 14.9704 0.811359 6.72127 -20.082 -15.4085 -14.9718 +552 2 15.0111 2.04928 7.59859 -2.39038 6.78983 -5.63995 +553 1 5.04086 13.0229 18.4653 -16.526 -4.40388 -18.1368 +554 2 5.51186 13.0765 0.64315 8.46246 3.02378 17.117 +555 2 5.66208 13.3388 17.7987 -1.33855 -1.44241 4.73678 +556 1 15.3891 8.54048 18.1286 -6.10206 -9.0298 20.9903 +557 2 15.6702 9.06907 17.396 9.32842 15.5064 -17.6225 +558 2 15.3407 9.15597 0.239346 -3.25407 -2.5962 -5.00154 +559 1 12.0788 3.07289 18.3192 12.549 -10.6185 1.49283 +560 2 12.5729 2.60825 0.359083 -9.10594 9.02489 11.6275 +561 2 12.4194 2.60778 17.5512 -7.87867 2.96301 -9.52933 +562 1 13.1665 12.6793 5.14706 7.93439 -3.9476 12.1924 +563 2 13.7696 11.9755 4.86963 -4.91093 -2.83846 -5.3825 +564 2 13.2489 12.6724 6.11347 -1.2685 5.53825 -1.32442 +565 1 6.04116 7.20215 0.12064 7.04453 6.18255 -12.3628 +566 2 5.83851 8.12748 -0.154348 1.72696 -16.7644 14.2262 +567 2 5.20617 6.73813 0.252386 -0.898724 4.83199 2.26117 +568 1 17.6547 15.8889 14.9543 35.0528 -4.14946 21.8068 +569 2 16.7907 16.2722 15.0644 -14.9966 1.76464 -15.1201 +570 2 17.9353 15.7106 14.0428 -17.4402 7.26196 -6.43436 +571 1 13.1733 0.917277 16.6395 -12.3557 8.76343 2.76166 +572 2 14.0527 0.785776 16.9891 12.1183 -2.33791 -0.0845054 +573 2 12.8033 0.0287439 16.599 0.155899 -2.85039 -4.8341 +574 1 10.9713 14.5555 7.36537 -14.2255 -14.9035 9.86762 +575 2 10.1709 14.1495 7.79489 23.622 7.7433 -12.5051 +576 2 11.716 13.9517 7.54396 -5.74804 5.50666 -0.0050929 +577 1 17.5337 8.50243 2.08938 -5.40396 -31.7286 -5.54565 +578 2 16.6651 8.377 2.51924 11.1588 5.07358 -2.60802 +579 2 17.6234 7.66639 1.54889 -0.0314299 30.6214 9.39113 +580 1 12.3599 7.90174 1.98937 3.23567 -16.3128 -6.49447 +581 2 11.7961 8.65526 1.85661 -2.62113 17.411 2.96359 +582 2 12.056 7.28247 1.30894 3.22552 -0.339632 3.88847 +583 1 11.9987 14.6627 10.3756 12.942 21.9862 15.1728 +584 2 12.1481 13.8459 9.95801 9.02096 -31.6093 -18.7525 +585 2 11.0572 14.7574 10.3761 -24.4084 6.55121 -1.49817 +586 1 6.83545 6.97591 15.5496 -11.1581 -18.4558 -7.96595 +587 2 7.75433 6.91064 15.3306 20.697 -3.79434 -9.10488 +588 2 6.829 7.75126 16.0755 -7.29309 23.7102 19.2635 +589 1 8.01446 4.61093 13.3684 -42.1501 -10.3174 -21.1074 +590 2 7.18404 4.82769 12.8493 26.4504 -9.34552 12.0218 +591 2 8.34807 5.45326 13.6307 9.05324 16.4922 6.04122 +592 1 13.4266 12.1814 14.3212 -6.42777 -0.785601 -11.9683 +593 2 13.0158 11.3184 14.1828 2.17743 -6.12306 4.21948 +594 2 13.8675 12.3621 13.4761 -0.124998 4.48227 1.48561 +595 1 14.6825 9.43166 7.27492 9.85972 28.3832 27.9741 +596 2 15.5174 9.92891 7.46534 -14.0141 -13.1604 -8.13985 +597 2 14.0576 9.79435 7.94424 7.51867 -12.8522 -19.303 +598 1 12.7091 16.9592 3.18265 16.188 -54.3303 -7.24671 +599 2 12.7269 17.2341 4.07879 2.36138 14.6014 27.6129 +600 2 12.279 17.6213 2.6979 -21.2589 39.1636 -23.5451 +601 1 1.03636 7.13727 17.3765 4.75158 -4.20474 15.7377 +602 2 0.172257 7.41544 17.719 4.25282 -10.0113 -2.57097 +603 2 1.1139 7.5113 16.5007 -3.03142 8.85376 -8.54904 +604 1 12.882 5.00728 15.6915 -13.3168 2.35737 2.40623 +605 2 13.5933 4.38686 15.8029 14.6532 -13.0711 -0.480408 +606 2 13.3236 5.8608 15.7721 -0.35756 9.80313 -2.71263 +607 1 2.42233 3.36085 5.14652 -1.4819 -20.4954 -28.2661 +608 2 1.78479 3.2289 5.83557 -10.283 -5.3637 15.3955 +609 2 2.79623 4.21009 5.29825 15.429 26.5106 10.9541 +610 1 8.29403 11.1124 13.578 -10.7346 17.3121 -71.8204 +611 2 8.44225 10.8317 14.4188 2.94407 -17.9634 86.1576 +612 2 9.02074 10.6663 13.1421 6.44484 1.50589 -14.4967 +613 1 12.9406 1.47026 13.2897 0.354478 -37.8914 22.4103 +614 2 13.6523 1.40022 12.6671 11.2026 2.70228 -18.849 +615 2 12.6313 2.34545 13.2159 -11.96 35.388 -6.53093 +616 1 6.51021 13.5896 2.17003 14.8824 -7.80817 -21.2989 +617 2 5.87965 13.8406 2.83705 -10.6705 6.78718 16.3658 +618 2 7.14425 12.9838 2.58896 -6.69863 7.51381 1.45504 +619 1 15.9112 6.50963 12.6885 16.1371 8.47906 -9.98075 +620 2 16.4229 7.02402 12.0187 -10.4906 -13.771 14.0264 +621 2 16.4535 6.54884 13.5054 -11.4677 1.21509 -6.34034 +622 1 16.8027 0.705691 9.58115 1.1294 19.8318 -8.72086 +623 2 16.927 18.412 9.70296 -4.50862 -18.5326 4.35013 +624 2 16.4766 0.834017 8.66778 -1.09927 -3.21438 5.98018 +625 1 6.10776 11.6244 8.30817 -7.08025 31.3016 10.3571 +626 2 5.31117 11.3633 8.78813 -2.85933 -0.839224 -1.79107 +627 2 6.50869 10.8152 8.04097 10.2317 -24.1838 -9.43106 +628 1 2.82434 8.71866 0.367104 27.0695 8.27339 20.5452 +629 2 2.22535 8.20379 18.5266 -22.1964 -28.7808 -30.261 +630 2 2.24775 9.38106 0.731441 -2.19807 14.7641 10.188 +631 1 10.1092 10.4559 6.56308 -0.703462 -11.3062 5.02538 +632 2 10.4957 9.70218 7.03882 1.80116 3.11275 -0.176711 +633 2 10.5447 10.4553 5.70619 3.2422 0.610478 -8.25928 +634 1 6.77867 15.7679 6.62657 -1.68281 -11.8864 -9.65654 +635 2 7.19346 15.995 7.46341 4.74707 6.17504 0.549944 +636 2 7.26738 16.2069 5.90636 -4.84487 7.71134 8.89334 +637 1 6.4599 12.9833 5.69613 7.9309 12.6721 2.99822 +638 2 6.6611 13.9194 5.88765 -3.42976 -10.7335 1.27405 +639 2 6.10779 12.6203 6.51977 -0.735551 -2.83601 -1.42622 +640 1 16.7784 12.5316 9.7686 6.64513 16.9355 2.79564 +641 2 16.9553 11.9755 9.0112 -1.14761 -14.6768 -5.4217 +642 2 17.3143 13.3158 9.58219 -8.26404 -2.19889 6.01862 +643 1 6.14902 2.92407 2.76687 9.25618 8.55881 7.16487 +644 2 6.44579 3.84137 2.53376 -9.69316 -20.3131 -2.03165 +645 2 5.73381 2.47389 2.01355 1.00911 7.28801 -3.60537 +646 1 10.8507 3.14979 3.2526 -8.20022 -5.11042 -1.435 +647 2 10.2526 3.87795 3.44424 2.28516 4.24005 3.08111 +648 2 10.4324 2.67577 2.52169 3.50832 1.84172 1.62718 +ITEM: TIMESTEP +60 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.82699 6.8727 17.8888 7.11742 1.34647 0.262135 +2 2 7.99 7.13914 18.2565 -12.0864 4.19935 8.4109 +3 2 8.62901 6.07007 17.4227 -0.244169 -11.025 -10.1388 +4 1 18.7394 8.29949 6.7561 2.34576 -2.93089 -42.9257 +5 2 0.440553 7.9626 5.87052 -19.1153 18.5732 27.9896 +6 2 0.571955 7.78688 7.39134 9.59653 -12.4008 18.4821 +7 1 8.51178 18.783 6.87295 -6.05415 -5.58023 12.25 +8 2 9.39304 0.279078 6.53812 12.1519 1.3365 -4.9205 +9 2 7.9628 0.741428 6.37316 -1.87647 6.654 -3.74148 +10 1 6.53357 1.7197 11.6944 -32.7429 -8.61455 3.24653 +11 2 5.73579 2.18358 12.0739 27.4882 -10.0969 -10.5409 +12 2 6.18445 0.855878 11.3477 8.95005 26.2974 10.8481 +13 1 6.96535 5.62987 2.3961 35.6431 -32.0928 -15.0783 +14 2 6.38293 5.93218 3.05619 -24.6612 16.4463 30.6134 +15 2 6.84916 6.21974 1.66578 -5.97717 13.8881 -18.7681 +16 1 16.1974 10.2298 16.1222 0.837184 6.4903 1.28091 +17 2 17.0743 10.6189 16.0747 2.49014 -9.13099 -5.48379 +18 2 15.6463 11.0038 16.2733 -2.87215 -2.05097 1.79245 +19 1 10.6702 14.9469 2.31164 21.9083 12.0632 13.3283 +20 2 10.6818 14.2862 3.02723 -4.43621 6.7471 -1.73288 +21 2 11.263 15.6645 2.64965 -13.2726 -10.9824 -6.65814 +22 1 17.1701 8.22403 10.7142 -10.4028 1.03109 3.96163 +23 2 16.5672 8.79102 11.2349 7.05768 -1.94337 -2.70487 +24 2 17.9333 8.77716 10.499 4.44622 1.4788 -2.07857 +25 1 14.6797 15.9035 16.4693 -22.461 3.39408 -16.7947 +26 2 13.7484 16.2021 16.2951 24.3498 -9.2952 11.1 +27 2 14.6463 15.3225 17.2482 2.4047 10.3841 -3.14234 +28 1 12.1037 13.3669 0.54665 -3.27844 11.868 -6.89748 +29 2 11.8248 13.5865 18.2899 5.63772 -9.83511 -2.25753 +30 2 11.6388 14.0254 1.08354 0.310925 -7.08728 5.11983 +31 1 9.3344 5.48343 3.92748 33.8763 5.32583 -18.4372 +32 2 8.84687 5.22044 4.68611 -23.4915 -4.94858 24.7343 +33 2 8.7079 5.56619 3.20676 -14.265 -0.820383 -3.61874 +34 1 1.71101 4.06482 11.6122 14.6912 -29.1046 6.03323 +35 2 1.58258 4.96723 11.8918 -1.25551 20.6962 3.43651 +36 2 2.34968 3.65386 12.2459 -15.6865 7.58906 -11.285 +37 1 2.0576 6.82445 8.24528 12.7796 11.6573 13.2587 +38 2 2.61911 7.2356 8.94539 -14.081 -6.70064 -12.0447 +39 2 1.89349 5.9205 8.55263 1.83531 2.80349 -1.77694 +40 1 5.39864 4.45401 7.95786 1.68333 5.33174 7.59028 +41 2 5.55249 3.50745 7.87389 -3.64833 -7.88894 -5.24716 +42 2 4.83854 4.74959 7.2381 -8.525 -1.92619 -10.156 +43 1 3.30216 2.93412 17.4505 12.3495 -29.8256 -18.8762 +44 2 3.92727 3.3713 16.8479 -0.637689 -1.64749 6.41076 +45 2 2.89532 3.6118 17.959 -11.8167 26.1488 16.8317 +46 1 7.4312 5.4352 6.15055 3.3909 -0.433751 -53.1737 +47 2 7.92374 5.97877 6.73644 15.9967 14.3411 25.9486 +48 2 6.95714 4.77392 6.61797 -10.969 -14.5624 25.0012 +49 1 9.79304 6.98632 12.0044 -11.2776 3.50532 -30.3595 +50 2 10.3262 6.37648 11.4616 -6.26095 5.52929 9.55968 +51 2 9.10346 7.3395 11.3719 14.604 -9.64535 21.0978 +52 1 14.0819 3.68689 8.0984 5.37498 8.43639 24.1843 +53 2 13.9041 4.52495 7.65095 -1.63712 -2.30615 -0.914734 +54 2 14.2511 3.92795 9.04472 -1.39906 -3.736 -24.3353 +55 1 4.49163 17.2405 3.95076 10.4122 -13.5126 12.545 +56 2 5.41424 17.4498 3.85674 17.5711 4.37719 2.71306 +57 2 4.10795 17.4238 3.10711 -15.6864 12.0721 -17.6618 +58 1 16.4063 16.5742 10.3304 -30.4876 -1.09383 10.2792 +59 2 15.5552 16.587 10.8552 23.7267 -0.690427 -17.666 +60 2 16.1781 16.1401 9.48726 -2.06021 -0.342568 9.10707 +61 1 2.01216 4.81629 0.267482 -15.744 -7.33716 -25.0709 +62 2 2.32092 5.21812 1.07081 12.8803 9.20197 12.7852 +63 2 1.84588 5.54667 -0.35429 -3.07657 2.24499 6.46529 +64 1 11.4525 13.2643 16.3577 0.360612 25.402 13.2121 +65 2 11.0472 12.4174 16.5451 -7.76012 -9.6277 -2.94397 +66 2 11.9986 13.1376 15.5855 6.89063 -5.57893 -10.2697 +67 1 10.1527 10.9848 16.8633 -20.103 19.6526 2.73515 +68 2 10.5885 10.1542 16.8545 15.6291 -29.738 -2.50548 +69 2 9.22545 10.7635 16.7018 -0.592014 4.00252 0.856412 +70 1 11.7907 17.4531 13.47 6.77179 16.9038 -5.30963 +71 2 12.2429 16.8403 12.875 5.23267 3.61287 1.34276 +72 2 12.1771 18.3441 13.2664 -10.6628 -13.9509 7.62196 +73 1 6.44648 9.35189 12.2088 11.1766 16.4313 12.1054 +74 2 7.06476 9.1188 11.5034 -9.94127 -5.08631 1.40965 +75 2 6.99588 9.90362 12.7958 -7.62877 -4.94562 -4.27954 +76 1 16.2706 12.8594 2.68209 -1.75731 9.60563 4.91889 +77 2 17.1141 13.3556 2.57766 -16.4869 -7.21292 0.814827 +78 2 15.5397 13.5204 2.75856 19.4288 -8.85346 -2.79343 +79 1 0.706006 12.6575 5.91598 14.3848 1.31093 7.35726 +80 2 1.05127 12.3982 5.06653 10.4666 0.953953 -14.2919 +81 2 18.4268 12.7017 5.73438 -31.2224 -1.2993 2.30782 +82 1 5.26466 16.4058 18.4218 -16.1073 15.9927 3.08559 +83 2 5.67174 15.6665 17.9813 11.5666 -13.4602 -0.82172 +84 2 5.61268 16.4896 0.669718 7.09967 -3.66518 0.290508 +85 1 0.630514 7.71832 4.14439 -40.0144 -22.0429 16.8318 +86 2 18.6762 8.08291 3.48621 -5.56982 2.47832 -6.04635 +87 2 1.47362 7.93412 3.82987 48.6931 13.8203 -16.755 +88 1 3.15187 8.95984 6.48267 23.8542 8.38798 -14.0929 +89 2 3.71388 8.45844 7.06344 9.53544 -4.30832 6.22463 +90 2 2.31458 8.97258 6.8974 -32.9047 0.579586 11.7619 +91 1 7.26503 10.3427 16.2788 17.1997 0.0580756 -23.1821 +92 2 6.56569 10.7121 15.7432 -4.58149 2.66195 0.233626 +93 2 6.94547 10.3415 17.17 -9.40627 -4.59594 18.3856 +94 1 11.082 0.946861 5.00581 6.19269 9.74659 5.8053 +95 2 11.2852 1.82567 4.65658 -6.55006 -0.520752 -0.877191 +96 2 10.8571 0.430046 4.22808 -5.9868 -5.86677 -2.53499 +97 1 4.345 2.8292 13.2132 -1.27186 28.7368 -8.62995 +98 2 4.51529 3.21096 14.0791 1.17168 5.0352 0.572822 +99 2 4.2316 1.91147 13.3845 -6.13817 -32.6591 5.85186 +100 1 8.38376 10.2307 1.79685 4.09005 3.74222 -19.3624 +101 2 8.31491 10.9253 2.45197 -4.24337 3.92137 10.2746 +102 2 8.66929 9.45546 2.26885 2.27917 -12.8064 10.4703 +103 1 10.3305 1.70894 15.5022 6.01592 -1.55552 8.18831 +104 2 11.2875 1.57757 15.6324 -10.5356 -0.805047 -6.9053 +105 2 10.1546 1.87921 14.5629 5.4285 2.19916 1.25738 +106 1 2.65797 12.824 7.8537 2.67737 0.310449 -2.88199 +107 2 3.19441 13.4775 7.37699 -0.834696 -1.21778 5.43137 +108 2 1.94106 12.6113 7.24505 -1.36647 0.43678 -0.0339739 +109 1 3.78494 11.7026 5.05983 17.7759 13.7966 10.32 +110 2 3.63161 10.9725 5.64962 -3.29006 -9.81966 6.20688 +111 2 3.00915 11.823 4.52928 -13.3129 -0.91097 -10.8894 +112 1 6.77794 14.436 16.9596 -4.81268 9.99067 -5.99614 +113 2 7.54793 15.0018 17.1111 -0.926912 -4.93073 -4.17577 +114 2 6.38498 14.6674 16.0968 9.73202 -0.180074 3.30595 +115 1 14.2221 14.5157 3.27778 -13.9298 6.06594 9.9851 +116 2 13.8151 15.3779 3.06073 2.11094 -9.8452 8.88116 +117 2 13.8089 14.1856 4.11 4.80477 6.02161 -17.3229 +118 1 8.54544 18.1123 16.0497 -51.2002 16.193 -5.03192 +119 2 8.97127 17.2819 16.1484 30.3531 -21.0569 10.3371 +120 2 9.10378 0.243275 16.0887 21.8256 4.58901 -4.15396 +121 1 4.6724 1.65079 4.89395 -0.428695 -35.2982 26.3678 +122 2 3.9342 2.19791 5.10489 -21.2256 11.2309 2.3914 +123 2 5.17375 2.14476 4.28849 23.1392 22.1006 -30.0951 +124 1 14.9936 12.6291 16.4673 -19.77 11.4375 -24.1827 +125 2 14.4795 13.0601 17.1383 2.64859 2.32978 20.7439 +126 2 14.3496 12.6271 15.7247 18.4778 -8.83273 3.74622 +127 1 15.7172 18.4491 16.8771 -38.7365 1.31848 -37.9731 +128 2 16.4119 18.3751 17.4758 43.0193 1.36234 40.9307 +129 2 15.3332 17.5625 16.8778 1.44654 -2.1141 -5.88546 +130 1 1.31769 1.23679 16.6144 -6.54563 -5.62507 -9.64947 +131 2 2.12749 1.70533 16.7963 11.1847 9.69542 4.67012 +132 2 0.698368 1.60678 17.2434 -6.22801 1.29783 7.94738 +133 1 18.1828 4.42633 15.9571 -10.2445 4.38521 4.02875 +134 2 18.0727 3.95797 15.1342 -1.32851 -5.12675 -7.69371 +135 2 0.442412 4.30859 16.2307 9.57607 0.794437 2.0974 +136 1 12.2114 16.9885 16.1505 19.3184 14.9656 -43.0527 +137 2 11.4192 16.582 16.4369 -30.1172 -13.2398 21.5491 +138 2 12.0643 17.0779 15.1772 3.25614 1.68146 17.8786 +139 1 16.0795 2.58494 18.1555 11.3664 -10.2705 19.274 +140 2 15.8693 3.49863 18.3 -12.3112 17.2654 5.58069 +141 2 15.8977 2.41247 17.2454 -5.4363 -1.34473 -24.067 +142 1 6.67972 13.8354 10.1508 -8.25744 -4.72138 -13.3408 +143 2 6.54568 13.5231 11.0561 -0.87434 -6.75398 -1.82198 +144 2 6.44555 13.1152 9.51962 7.50297 7.52708 13.7797 +145 1 10.1393 18.4632 2.72581 -2.6903 -13.3312 7.25948 +146 2 10.3702 0.440572 2.04373 3.08075 7.1003 -10.4416 +147 2 9.34905 18.0295 2.38643 -2.95732 2.6687 3.95308 +148 1 3.05039 17.7207 6.12428 0.448774 -3.44066 -6.39261 +149 2 2.22716 17.4884 5.64326 9.1847 7.623 2.40325 +150 2 3.74061 17.8548 5.44564 -15.5509 -1.85687 4.81473 +151 1 12.5974 16.8374 7.98109 22.5462 3.91689 -18.138 +152 2 11.9813 16.1063 7.98041 -18.255 -3.99171 0.854341 +153 2 12.4106 17.4726 8.66951 -8.78709 2.06599 13.7307 +154 1 14.8906 15.2874 8.20197 12.2291 6.1037 -1.40009 +155 2 14.0169 15.6824 8.32954 6.14586 6.92547 -6.68196 +156 2 15.3058 15.6925 7.40177 -13.6896 -13.6819 15.1947 +157 1 17.774 18.2462 0.317021 16.5526 -0.292921 -8.65749 +158 2 18.517 17.6459 0.018512 -14.2865 26.6269 11.4024 +159 2 18.1212 0.514643 0.485201 -2.53379 -23.9559 -4.59837 +160 1 0.824062 10.4854 1.38532 29.0751 41.1299 -24.8426 +161 2 0.152225 9.85957 1.54468 -35.7643 -25.6114 8.77961 +162 2 0.463481 11.18 0.764874 10.1431 -20.9883 20.7352 +163 1 1.76832 12.2434 3.3342 -0.376699 -6.62105 -8.54196 +164 2 1.60728 11.5206 2.66813 -0.613387 21.7926 10.4725 +165 2 1.98383 13.0773 2.86566 -4.64348 -14.8628 -2.7215 +166 1 0.631416 17.2455 4.93339 -1.94983 -6.83399 6.66588 +167 2 18.8682 18.1422 4.98859 -2.83763 -23.6492 7.38562 +168 2 0.299607 16.5671 5.5918 8.11627 31.0276 -16.6779 +169 1 1.13057 0.905706 9.36586 -12.3827 -0.18715 22.5068 +170 2 1.31261 0.747855 10.3312 -4.25497 -2.51626 -23.3877 +171 2 0.268645 0.477115 9.21068 10.8181 5.54227 0.850191 +172 1 16.7346 2.37332 13.3038 3.72479 1.84576 21.5886 +173 2 16.9761 2.56684 12.4028 0.0757035 3.67621 -15.1405 +174 2 16.5678 1.42686 13.3713 -2.69734 -3.58003 -5.961 +175 1 2.71222 15.8556 12.0453 -23.2953 18.5694 10.7935 +176 2 3.02055 15.4773 12.8617 6.20357 -6.16654 7.20198 +177 2 3.26455 15.5565 11.3309 7.18341 -3.43964 -7.05157 +178 1 16.426 15.6488 6.1101 -14.7609 -25.4644 9.17481 +179 2 17.2826 15.6571 6.51544 16.1879 -4.44611 5.83009 +180 2 16.438 16.358 5.49538 -5.11113 23.225 -23.4349 +181 1 5.76882 5.13637 11.8122 -12.0704 17.5482 5.11471 +182 2 5.44081 5.9885 12.2003 4.95719 -19.5528 -5.70673 +183 2 5.01212 4.52871 11.8104 6.55972 2.89024 2.61392 +184 1 15.1343 4.86498 0.81249 17.6468 10.3526 -37.7608 +185 2 14.8624 4.60472 1.67155 -6.094 -8.43385 31.413 +186 2 14.42 5.38891 0.454388 -5.76674 3.16257 -0.979918 +187 1 16.354 16.4047 2.01729 -13.9507 10.6217 3.88258 +188 2 15.8491 16.8174 2.76015 19.926 -7.04016 -11.695 +189 2 16.7635 17.1307 1.5183 -3.64457 0.258913 2.52225 +190 1 0.229093 4.84171 3.85636 -16.5361 -39.1535 -9.01102 +191 2 0.280674 5.76384 3.97165 5.27146 43.6678 4.59383 +192 2 0.903367 4.46589 4.41298 10.8 -4.72049 2.86342 +193 1 2.98031 15.0696 15.1724 7.38994 17.2595 -26.1187 +194 2 2.78389 14.6733 16.0132 -4.59533 -4.91572 22.4357 +195 2 2.69496 16.0061 15.2442 -6.09825 -12.2809 0.399162 +196 1 1.14224 14.6486 9.53301 9.69931 -12.3423 3.57818 +197 2 2.08157 14.8372 9.66442 -5.69448 4.03807 -1.75917 +198 2 1.10168 13.6946 9.72739 -6.61933 10.5759 -2.74939 +199 1 13.5148 16.5367 11.5259 11.0739 -5.14125 9.92262 +200 2 13.0998 17.2443 11.0437 -3.0151 15.655 -8.61356 +201 2 13.0781 15.7617 11.1648 3.09342 -5.90037 -0.559148 +202 1 4.6468 1.4492 0.760442 21.9419 17.6404 -6.63386 +203 2 4.03376 2.00221 0.272437 -3.30289 2.18566 -6.21296 +204 2 4.11186 0.849122 1.26962 -7.6403 -10.762 3.4591 +205 1 1.46385 18.5705 11.8684 11.5971 1.37494 19.5738 +206 2 1.40443 0.572196 12.6059 -0.800227 -11.3118 -6.50307 +207 2 2.03902 17.8403 12.1929 -11.6325 11.1906 -9.16825 +208 1 11.4878 10.1514 4.00495 -23.562 -17.5625 40.225 +209 2 11.4445 10.4449 3.12053 -0.0273244 15.9845 -32.1431 +210 2 12.4087 10.0544 4.20335 22.0666 -0.101113 3.57488 +211 1 8.17978 12.1587 3.71493 28.653 -3.15285 -17.361 +212 2 9.01377 12.5671 3.97927 5.41625 0.887106 1.05136 +213 2 7.604 12.3558 4.43149 -23.5411 2.07968 29.6007 +214 1 14.5452 4.04195 3.30356 -17.0528 -5.31405 -8.64237 +215 2 15.1661 4.06926 4.02931 6.41379 4.8272 12.7333 +216 2 13.7233 4.44982 3.62226 2.87412 -0.159853 0.628569 +217 1 5.66111 1.64664 7.53337 47.3068 24.6854 -47.7691 +218 2 4.99385 1.2169 7.99076 -47.8059 -33.9417 34.4755 +219 2 5.55481 1.33937 6.59792 -2.0798 14.2024 17.8553 +220 1 17.8737 1.09537 4.84004 -13.6202 -14.1831 4.02096 +221 2 18.464 1.49436 4.20233 9.91759 7.15437 -5.32228 +222 2 17.8561 1.60546 5.65338 7.58498 6.35358 2.28946 +223 1 6.84561 9.39092 4.51119 3.77645 -4.79561 13.9854 +224 2 6.80242 9.62767 5.4641 3.30223 -6.77647 -16.668 +225 2 7.74702 9.0401 4.34673 -10.1352 5.61637 3.28246 +226 1 2.64818 14.8733 2.0031 -12.6643 -4.21043 8.13073 +227 2 3.39044 14.7832 2.61388 1.60205 1.10943 -1.58393 +228 2 2.93662 15.3311 1.21566 8.61024 -0.712779 -4.79925 +229 1 17.3356 12.9304 13.2091 0.397713 16.5012 -11.0143 +230 2 16.4513 13.2838 13.3976 5.15185 -2.46087 0.53778 +231 2 17.8465 13.7314 12.9621 -7.21788 -13.1567 2.02539 +232 1 14.9178 10.5628 1.45295 0.32879 33.5889 18.189 +233 2 15.3786 11.3985 1.79277 -12.1624 -32.8958 -12.3175 +234 2 13.9692 10.6935 1.62732 12.9477 -1.40805 -3.43718 +235 1 5.70482 6.69167 4.56094 -12.9541 28.0444 -8.31435 +236 2 5.76223 7.67071 4.46331 5.24004 -15.8993 1.97075 +237 2 6.3673 6.43877 5.21208 3.70858 -3.97365 0.601716 +238 1 7.97185 8.33683 10.3069 8.6941 -15.2025 -3.68424 +239 2 8.60404 8.92215 9.84221 -9.13329 -6.11086 -5.89913 +240 2 7.51742 7.70171 9.70626 6.59476 18.8917 -0.227694 +241 1 13.4177 18.464 5.71198 21.9916 6.6123 -14.6219 +242 2 12.6947 0.421284 5.51228 -9.11836 -2.12279 2.23123 +243 2 13.1839 18.0173 6.51737 -9.90438 -14.4062 13.6987 +244 1 0.0221035 2.62655 0.261444 12.6472 -47.1951 11.8456 +245 2 17.7527 2.75577 18.6598 -10.3686 10.7513 -7.61459 +246 2 0.546882 3.40438 0.188377 7.87852 33.0005 -3.15527 +247 1 12.8067 10.9927 9.75832 44.9647 -24.4125 8.46131 +248 2 11.8751 10.9314 9.65932 -31.4773 -7.30673 -3.09024 +249 2 13.1121 10.0761 10.034 -17.0663 24.2241 -8.13324 +250 1 0.673563 12.1459 11.0385 -14.9158 10.2345 17.3916 +251 2 18.3756 12.1565 11.2954 6.68564 0.0119082 -11.299 +252 2 1.10384 12.3853 11.8646 9.18612 4.40652 0.693569 +253 1 5.14721 7.33361 13.3929 15.7357 3.63047 1.84442 +254 2 5.59488 8.13358 13.0475 0.482915 -12.4288 -2.35902 +255 2 5.71887 7.03407 14.1269 -8.93121 6.52874 -3.37327 +256 1 1.18567 6.84505 11.8697 14.6786 34.5125 12.17 +257 2 0.393465 7.21987 11.4553 4.74321 -4.21777 2.31791 +258 2 1.70022 7.64215 12.2222 -16.972 -31.3024 -13.5319 +259 1 15.4816 9.69158 12.3277 9.90347 -39.8653 -1.57959 +260 2 15.3406 10.5924 12.1653 -13.2531 41.4735 -11.5871 +261 2 15.406 9.62533 13.2698 1.46249 -6.23285 16.1579 +262 1 16.5413 12.6347 5.5059 7.75274 -6.4804 14.118 +263 2 16.3104 13.5445 5.70094 -2.97213 12.2972 0.10227 +264 2 16.3923 12.5258 4.56955 -2.98329 -0.0504447 -18.3871 +265 1 6.30461 9.82716 0.0624729 6.72618 23.4574 16.6882 +266 2 5.51437 10.3287 0.304315 -0.069722 -0.440899 2.51054 +267 2 6.96842 10.0501 0.765687 -11.6212 -9.0506 -14.676 +268 1 12.2588 6.10042 4.03099 15.0483 24.7381 -3.94445 +269 2 12.3021 6.98896 3.58767 -5.34003 -28.327 1.95056 +270 2 11.3325 5.86569 4.06669 -11.2394 -4.89225 -2.88949 +271 1 0.336489 12.822 0.136131 -4.0328 -4.68121 -1.73262 +272 2 -0.0692718 13.3776 0.815875 4.64589 5.49593 0.971726 +273 2 18.45 12.9344 17.9884 -7.92492 5.13291 -5.47118 +274 1 3.58866 18.6351 8.62238 -6.65617 9.61834 5.79691 +275 2 3.41901 18.3768 7.70859 0.297411 -7.32139 -0.213682 +276 2 2.71275 0.31261 8.92207 15.7588 -5.16119 -5.17535 +277 1 7.50496 17.418 4.49772 -12.5742 -28.6928 8.65377 +278 2 7.55283 18.3491 4.58726 6.16277 33.1384 2.27358 +279 2 7.74423 17.2559 3.59134 -1.33953 -2.22923 -11.883 +280 1 9.26392 17.1331 12.2129 -23.7136 4.99112 -6.35848 +281 2 9.34774 16.2465 11.866 0.0093118 -9.2577 -7.50778 +282 2 9.98892 17.2487 12.8038 23.7327 3.38143 15.862 +283 1 13.3751 13.0337 7.97577 10.7478 10.6887 -13.5108 +284 2 13.3787 12.2298 8.50206 6.89696 -2.46192 7.10708 +285 2 14.2592 13.4885 8.01338 -22.4634 -9.00878 7.77512 +286 1 14.8592 2.99547 15.3735 -5.27851 1.66435 23.9116 +287 2 14.1885 2.32373 15.2402 -1.63897 -5.65445 -5.41614 +288 2 15.4149 3.00295 14.6023 9.16888 -1.78425 -15.607 +289 1 9.86925 15.6154 16.9672 4.33331 -1.89849 4.26663 +290 2 10.4152 14.8537 16.7052 -6.80597 -3.90746 -0.277805 +291 2 9.57771 15.4416 17.8827 0.419377 0.378738 -9.64067 +292 1 11.2678 8.44973 16.5939 -8.08747 -14.0791 2.0813 +293 2 10.6693 7.85604 16.0792 7.94549 12.4538 10.9378 +294 2 11.4172 8.01973 17.4598 -1.80582 0.647834 -14.6449 +295 1 3.91551 18.1683 16.8005 9.39931 12.2215 14.3903 +296 2 4.49606 17.6509 17.3756 -3.52447 -10.1131 -6.81095 +297 2 3.95318 0.38369 17.2365 -5.94998 0.470214 -7.14863 +298 1 2.19966 4.20574 8.91394 -16.952 6.25086 -28.7566 +299 2 3.11163 4.1112 8.67966 19.1354 -3.54458 -0.459765 +300 2 2.10589 3.95692 9.81579 -0.00585893 -3.49833 31.5267 +301 1 9.86514 10.3731 9.72031 15.6542 -41.5135 2.74879 +302 2 9.61489 11.2182 9.40808 -14.4527 35.546 -8.7168 +303 2 10.0569 10.3888 10.6595 -0.965326 6.48855 10.4451 +304 1 9.65603 0.92083 10.8651 15.4128 -5.93628 -1.69563 +305 2 9.35399 0.0448876 11.1808 -6.92756 10.8331 -8.061 +306 2 9.08478 1.27687 10.159 0.925367 -10.2687 5.27886 +307 1 9.17601 15.08 10.2001 28.4704 15.1584 7.58672 +308 2 8.86011 15.9493 9.94215 -4.94078 5.46469 -8.90142 +309 2 8.40516 14.5378 10.1682 -22.1716 -15.7686 -1.61012 +310 1 0.908908 9.65777 10.2661 1.02783 -39.6886 -13.0526 +311 2 0.968686 10.5462 10.5861 7.37828 17.5094 1.10535 +312 2 1.79128 9.34954 9.98968 -11.6106 9.29057 7.26807 +313 1 16.9796 4.82858 8.10785 29.2892 -10.1291 -25.9715 +314 2 16.4029 5.49318 8.42182 -23.755 22.5857 11.698 +315 2 16.8784 4.07707 8.6652 -3.89501 -13.8815 13.5617 +316 1 14.7893 14.6979 0.173135 5.39554 -7.96858 -12.7144 +317 2 15.0505 15.3823 0.785417 9.36392 5.93735 12.263 +318 2 13.9789 14.3219 0.494521 -15.109 -8.03615 11.244 +319 1 3.74323 11.0124 9.54886 4.38849 -4.14114 10.1409 +320 2 3.63158 11.395 10.4392 1.27308 -1.67175 -3.21468 +321 2 3.24423 11.5652 8.93525 -2.74645 9.31742 -2.2917 +322 1 11.2573 10.7534 1.46897 -2.74628 -20.4518 -2.00657 +323 2 11.6064 11.5358 1.05536 3.45865 20.4344 -8.16659 +324 2 10.3358 10.6724 1.18755 -1.77969 3.26872 -0.743535 +325 1 13.1779 7.19199 12.7182 14.2184 -9.05364 3.75753 +326 2 14.115 6.87295 12.7816 -17.4164 8.42328 -3.38551 +327 2 12.6212 6.40428 12.8017 3.66516 -2.90974 1.8722 +328 1 9.6094 1.86333 0.961036 -1.66559 10.1622 -20.0065 +329 2 8.74982 1.7634 0.476399 21.9169 -1.84649 8.18396 +330 2 10.2659 2.29351 0.366445 -15.6421 -6.48907 5.12748 +331 1 10.6591 13.4925 4.58018 -19.1141 -0.630091 -16.1529 +332 2 11.5305 13.1262 4.70232 12.5696 -8.82773 5.21944 +333 2 10.586 14.1761 5.24203 -0.728557 4.94256 14.6221 +334 1 14.495 1.73909 10.9749 -8.14936 -7.82556 -5.33359 +335 2 15.2253 1.30703 10.5146 2.44721 2.03735 2.44955 +336 2 14.6402 2.68373 10.8341 0.821335 1.15578 7.11863 +337 1 14.5247 12.1307 11.6327 6.29346 4.76638 51.459 +338 2 15.3146 12.4097 11.1999 18.4985 9.73575 -23.8815 +339 2 13.8662 11.9319 10.9987 -20.1843 -8.01501 -29.1382 +340 1 8.1934 5.08514 9.85848 20.6286 -7.50881 -18.2265 +341 2 7.39102 5.12991 10.3666 -14.5844 -3.05188 8.40055 +342 2 8.26178 4.1705 9.49849 -5.86813 14.6103 10.9415 +343 1 1.56363 16.9354 18.4208 -1.17306 -23.9048 5.52961 +344 2 2.13897 17.2639 17.7268 3.56106 5.06395 -9.30964 +345 2 1.54669 15.9596 18.2963 3.84009 16.9778 0.440392 +346 1 1.49268 17.3196 15.3241 -27.5122 8.95969 8.58328 +347 2 1.46041 18.2525 15.6844 -4.86102 -31.3543 -7.55486 +348 2 0.570896 16.9106 15.346 29.8648 20.9529 0.539048 +349 1 3.59911 5.78915 6.06648 9.03859 -15.9659 -5.84137 +350 2 3.1214 6.40715 6.60976 -11.746 7.94276 10.4286 +351 2 4.15987 6.31414 5.47841 1.03618 -2.86439 -0.897012 +352 1 12.5136 9.4824 14.2234 -14.5482 39.9006 11.9441 +353 2 12.9252 8.74241 13.842 20.5687 -36.5434 -22.703 +354 2 12.2915 9.17254 15.1019 -4.72781 -1.84288 9.93497 +355 1 4.05984 15.2792 6.9471 -25.1121 -18.1042 13.4141 +356 2 3.54373 16.0393 6.6659 -0.213909 7.77754 -0.115815 +357 2 4.94872 15.4739 6.70425 29.3053 8.29501 -4.075 +358 1 0.70733 8.67925 15.049 -6.53077 -6.52645 2.33041 +359 2 0.403057 9.59211 15.0995 2.0449 7.24241 -1.44461 +360 2 1.39578 8.67212 14.3782 6.73055 2.7204 -4.7895 +361 1 12.9505 8.27543 10.2426 2.52256 -9.36522 19.2887 +362 2 13.7222 7.81068 9.89429 1.56507 0.683648 -5.24915 +363 2 12.8789 7.88642 11.1491 -0.00217653 14.5673 -16.6218 +364 1 15.3477 7.80216 3.55401 -12.532 5.83489 -12.7989 +365 2 14.4906 7.48222 3.33103 -16.8871 -2.65253 -29.4538 +366 2 15.2947 7.61797 4.46883 25.5814 -3.41235 36.6493 +367 1 17.266 6.70187 0.000674068 12.1195 -8.95496 8.26487 +368 2 16.7457 6.00049 0.395257 -2.87342 -9.15243 0.336143 +369 2 16.622 7.35704 18.4101 -17.4752 15.3525 -8.08793 +370 1 8.88335 6.95399 7.81342 26.8473 24.5973 -5.8387 +371 2 9.80542 7.33522 7.87938 -25.1058 -10.3372 -2.45861 +372 2 8.7714 6.40725 8.58367 -2.11125 -14.3958 16.4377 +373 1 12.3879 0.548843 1.24082 4.42765 -0.472301 -1.45686 +374 2 13.3265 0.730859 1.40339 -2.38609 2.78881 -0.689397 +375 2 12.2563 0.636326 0.292606 2.56041 -5.4085 -0.678049 +376 1 5.63248 15.1125 14.5468 -9.48886 -16.8407 5.02155 +377 2 4.69503 15.2624 14.7723 5.83199 -5.28539 -1.87026 +378 2 5.99589 15.9615 14.314 8.44734 16.7096 -6.42729 +379 1 3.85575 6.39433 1.75493 1.50274 -8.79363 8.51258 +380 2 3.48975 7.20754 1.41538 -8.87879 17.021 -2.96274 +381 2 4.03803 6.55873 2.69128 -1.36395 1.28851 -4.88856 +382 1 3.93631 11.5299 12.3893 -8.10483 -0.317118 -5.66906 +383 2 4.80663 11.9435 12.4577 -3.51298 -1.2689 0.972005 +384 2 3.32279 12.1457 12.8171 1.30391 -5.08042 -1.13556 +385 1 5.30379 3.85961 15.861 3.26535 -66.7729 -21.4105 +386 2 5.99128 3.21668 15.5051 -18.0074 17.9789 14.3955 +387 2 5.71814 4.68422 15.8683 22.7973 48.3912 1.26107 +388 1 14.279 10.1761 4.52146 -28.2637 29.6843 37.5781 +389 2 14.4726 9.82647 5.40905 -2.50301 -0.0307068 -4.88302 +390 2 14.7482 9.65242 3.92054 26.3189 -27.9191 -30.9088 +391 1 7.73542 17.3919 9.15036 20.9187 -26.1564 3.32362 +392 2 6.89787 17.6412 9.51878 -14.391 11.6651 3.78997 +393 2 7.98556 17.9488 8.40931 -4.18052 11.5531 -5.69175 +394 1 4.50439 14.5239 3.99264 11.0977 -23.3764 -48.4991 +395 2 4.56306 15.4325 4.20277 -1.38797 35.5351 15.6514 +396 2 4.31322 14.0314 4.76491 -6.35847 -16.1784 30.998 +397 1 14.1606 7.45193 15.811 -24.1382 -9.56247 -10.586 +398 2 15.0553 7.36431 15.524 24.9604 -3.00047 -8.7167 +399 2 14.2305 7.91189 16.6334 1.28104 8.01927 19.5585 +400 1 2.99693 18.3516 1.90386 -17.8633 -43.3253 -26.4279 +401 2 2.47403 17.7132 1.31624 19.6124 26.5697 18.0429 +402 2 2.33007 0.205152 2.36966 -11.145 11.7012 10.1025 +403 1 8.00896 1.59538 4.54643 -14.6935 -3.1209 6.18761 +404 2 7.42733 1.99671 3.8763 8.34922 -0.442348 -1.34208 +405 2 8.90764 1.54031 4.21745 2.64121 3.0498 -7.75206 +406 1 2.41984 14.15 17.6911 38.7391 17.8224 -8.42313 +407 2 1.65201 13.6768 17.9262 -26.9962 -21.4224 14.4939 +408 2 3.15619 13.6354 18.0755 -0.305296 5.75785 -2.4818 +409 1 0.881322 1.80893 13.8899 -12.9164 4.63859 7.1799 +410 2 0.998981 1.67187 14.8549 -5.47541 -0.367675 -15.7697 +411 2 18.568 1.96442 13.7158 18.7475 -1.65173 8.16576 +412 1 4.35626 0.108756 13.8915 -10.9503 4.16473 7.68997 +413 2 5.20313 18.36 13.6952 15.0207 -4.30703 2.98167 +414 2 4.18562 18.5651 14.8318 -0.53115 -1.77986 -5.89667 +415 1 7.21985 0.783193 18.3638 -3.94277 -6.88163 -25.1551 +416 2 7.12969 0.383485 17.4575 9.77138 9.98351 24.3944 +417 2 6.41237 1.28912 18.5059 -6.03182 -4.67978 5.08395 +418 1 15.9996 18.4041 13.9383 18.1315 -1.4443 -10.5581 +419 2 15.071 18.4425 13.7445 -14.3326 2.53282 3.85714 +420 2 16.1651 18.6473 14.8506 -8.9044 -3.87569 12.2679 +421 1 10.1939 4.54115 16.2821 35.3159 -4.68875 2.87762 +422 2 11.1919 4.40884 16.3129 -34.2522 14.5881 -3.55905 +423 2 9.86192 3.67371 16.0442 -3.43039 -7.24249 -0.81883 +424 1 15.9323 17.7355 4.44233 22.6638 -20.6434 -12.8847 +425 2 16.5412 -0.18272 4.5755 6.4476 10.7336 -1.45992 +426 2 15.0915 18.0468 4.70328 -34.4096 13.9436 14.4512 +427 1 6.99117 17.4686 13.8836 -42.0334 -7.7574 -17.1448 +428 2 7.47631 17.7428 14.6303 20.6357 14.1189 34.523 +429 2 7.65356 17.3815 13.215 15.8945 -3.28854 -19.4769 +430 1 13.2291 6.49408 6.5607 17.0277 2.09005 0.593761 +431 2 14.1816 6.76782 6.52286 -25.3304 -6.60509 -4.73803 +432 2 12.9166 6.35235 5.64754 5.89534 0.461784 7.57918 +433 1 7.85324 2.32148 9.35275 5.46391 6.9162 26.9577 +434 2 7.3686 2.17076 10.1976 2.69269 5.61176 -14.2633 +435 2 7.26481 2.08775 8.6472 -14.0957 -9.57593 -14.6111 +436 1 15.2023 14.7793 13.7187 7.74208 -16.2001 -4.59991 +437 2 14.8319 14.9596 14.5759 -4.08925 6.59301 14.3355 +438 2 15.0747 15.5488 13.1771 -7.6118 10.0658 -7.58078 +439 1 9.41047 8.32341 3.83123 -6.47708 13.1987 -5.34522 +440 2 10.2452 8.80483 3.85219 3.73168 3.01968 4.76716 +441 2 9.63137 7.40393 3.95808 -1.29777 -11.5098 0.542939 +442 1 17.7649 13.5922 16.3898 -11.4367 -25.6902 16.7919 +443 2 16.7908 13.5407 16.3666 6.32242 -2.67761 -0.626712 +444 2 17.9873 14.3645 15.8914 0.275374 22.0623 -11.5119 +445 1 4.92213 10.5724 2.8597 -4.83644 2.51404 -15.3254 +446 2 5.59736 10.2151 3.4378 8.5726 -2.027 3.49443 +447 2 4.66951 11.4171 3.23999 1.02108 -1.77966 3.70944 +448 1 3.74742 8.38157 10.0278 -2.2319 9.94706 -11.0912 +449 2 3.89489 9.30484 9.7273 -4.74563 -10.9217 8.16333 +450 2 3.84233 8.40088 10.9831 -0.997449 0.744123 6.62097 +451 1 15.9666 6.96875 6.01253 -14.8276 15.8227 3.08109 +452 2 16.7817 7.37259 6.30064 12.9112 7.94175 5.43996 +453 2 16.2196 6.12219 5.66656 5.41287 -21.5059 -0.527712 +454 1 15.1391 7.15478 9.02923 3.95319 -30.3017 38.192 +455 2 15.9165 7.52141 9.44882 9.73374 3.98045 10.059 +456 2 15.0698 7.60427 8.22918 -5.81948 28.1077 -46.3627 +457 1 6.22822 12.9188 12.7298 1.31868 -8.19268 -13.1839 +458 2 6.88351 12.2656 13.01 8.10485 3.82836 6.8834 +459 2 6.11855 13.5785 13.4162 1.19396 9.04898 12.3458 +460 1 12.1253 4.52441 13.1066 -23.5121 -14.293 -11.093 +461 2 12.4631 4.60406 14.0095 -9.44452 -2.69015 3.06865 +462 2 11.2831 3.97256 13.0795 31.8956 18.265 6.80246 +463 1 11.4055 8.12657 7.94639 -16.7563 2.96014 -17.3287 +464 2 11.9383 7.50834 7.43372 10.7385 -1.00284 -0.366803 +465 2 11.8652 8.24712 8.77366 5.83315 -1.26494 14.2429 +466 1 17.1037 10.8819 7.56719 -22.1575 4.54299 3.0458 +467 2 17.7705 10.2842 7.28531 25.0286 -24.4015 -2.83309 +468 2 16.8908 11.3655 6.76798 -3.05919 12.9941 -4.73253 +469 1 5.25302 18.1256 10.9232 26.818 -0.191878 -4.18594 +470 2 4.8269 17.8089 11.6994 -14.1597 -10.1429 18.6642 +471 2 4.64144 17.9747 10.2197 -19.8227 3.49229 -23.3423 +472 1 7.59833 17.4619 1.74995 8.37542 2.1771 -36.4257 +473 2 8.02215 16.748 1.21035 -16.0406 12.4022 13.5887 +474 2 7.374 18.1677 1.08602 7.01745 -13.9463 17.8331 +475 1 1.92633 12.907 13.6044 0.0880561 -5.46821 -16.7511 +476 2 1.47807 12.3822 14.2652 -4.39349 -7.86198 7.054 +477 2 2.32754 13.632 14.072 3.07665 17.0427 10.8635 +478 1 9.50987 6.80039 14.836 2.18935 -20.8269 12.8739 +479 2 9.79082 5.96037 15.3114 -4.54962 20.4196 -21.9392 +480 2 9.66995 6.7436 13.8735 6.47407 0.337666 8.03802 +481 1 15.2827 4.32341 10.7768 10.307 9.68599 -4.89646 +482 2 16.2397 4.0919 10.6916 -21.0983 9.39835 9.69703 +483 2 15.2266 5.10894 11.3663 5.46907 -15.4805 -5.79884 +484 1 11.3016 6.20596 0.140794 12.6043 6.09542 0.747046 +485 2 11.4786 5.29078 18.6344 12.8703 -22.3778 -2.75052 +486 2 10.381 6.25156 -0.0726873 -21.1699 14.4442 -0.985902 +487 1 -0.0715916 11.4097 14.9721 22.1692 -7.15633 35.3796 +488 2 18.1992 11.7732 14.1947 -21.0416 8.6568 -29.4322 +489 2 -0.201181 12.1402 15.5966 -0.594523 -4.50066 0.166015 +490 1 7.04588 9.27411 7.30476 9.145 16.929 -11.701 +491 2 6.64583 8.45304 7.57308 -6.76023 -15.305 10.0219 +492 2 7.98749 9.10222 7.20319 2.10913 -2.81405 2.65036 +493 1 18.3255 15.3308 12.2943 -10.9271 3.22482 1.76971 +494 2 0.551901 15.6023 12.004 16.2571 0.370549 -2.10144 +495 2 17.7334 15.6802 11.6169 -1.97195 2.58378 -3.71708 +496 1 16.5011 4.39937 5.27673 4.48444 11.2976 -56.5136 +497 2 16.7777 3.84422 5.96849 7.0389 -19.8316 37.8082 +498 2 17.2036 4.29545 4.59204 -6.79319 11.0559 14.2779 +499 1 17.7009 3.16012 10.7623 -11.0785 -13.2259 -8.21854 +500 2 -0.0365931 3.41438 10.9472 14.4195 -1.11458 2.04579 +501 2 17.6933 2.32175 10.2562 4.60522 6.17753 6.57508 +502 1 12.2846 -0.0106908 10.1146 7.09195 -37.1879 -10.2172 +503 2 11.3926 0.256016 10.2673 -25.9358 14.4274 7.98014 +504 2 12.8288 0.732071 10.298 19.2326 28.445 5.65892 +505 1 10.3866 9.75519 12.5017 -6.95633 -10.4248 -20.8372 +506 2 11.1983 9.82383 13.0055 7.4239 -2.70171 9.41801 +507 2 10.3064 8.80301 12.2683 1.05955 14.1529 10.144 +508 1 0.648708 2.774 7.07027 -1.36725 -4.55963 12.8723 +509 2 0.490272 3.61188 7.51443 -2.95105 4.17746 -2.75047 +510 2 1.10621 2.25999 7.75495 -4.79333 -3.92365 -3.87978 +511 1 0.307244 15.292 6.87913 -0.83379 49.2439 44.5727 +512 2 0.652444 15.3347 7.80405 -9.58611 -2.1659 -14.8737 +513 2 0.567348 14.4512 6.61032 15.5663 -52.8882 -22.8213 +514 1 17.056 6.99125 15.1184 -7.99596 0.858836 -4.56633 +515 2 17.7814 7.62276 14.9808 0.742784 -5.19204 3.90514 +516 2 17.4035 6.24942 15.6288 5.94943 -0.679765 0.413052 +517 1 9.13726 12.4999 8.01885 37.0353 0.885775 16.8739 +518 2 9.52568 11.8572 7.39973 -10.6447 2.68521 -0.695331 +519 2 8.21726 12.5875 7.87097 -30.0746 -3.81245 -10.8301 +520 1 1.21553 1.74407 2.88052 -2.59699 -2.39415 1.38589 +521 2 0.835324 2.14494 2.08419 1.70776 2.79001 2.24225 +522 2 1.71989 2.41102 3.3678 0.071784 1.92406 -2.09937 +523 1 4.07628 15.1457 9.88397 17.4433 -7.82557 -1.54586 +524 2 4.111 15.2412 8.92029 0.253189 0.655179 -3.36934 +525 2 4.94389 14.7737 10.148 -8.68797 4.30724 -10.2942 +526 1 7.35101 2.21809 14.6867 -7.35168 5.20952 -5.71558 +527 2 7.12719 1.57839 13.9999 0.606569 0.313122 2.88765 +528 2 7.62455 3.00796 14.1978 2.82745 -2.40467 5.3071 +529 1 18.457 14.6023 2.16488 -22.5257 23.4253 1.52633 +530 2 0.650438 15.0238 2.37846 9.31401 -4.06208 0.652559 +531 2 17.8015 15.3468 2.21006 9.59865 -20.266 -2.54542 +532 1 9.9778 2.69966 12.9163 0.655502 16.6224 11.2027 +533 2 9.96654 2.13525 12.1425 -5.01566 -7.38072 -9.38582 +534 2 9.27217 3.36428 12.8011 2.98946 -10.098 -0.342741 +535 1 2.95791 8.92102 13.0894 10.3197 8.62466 2.37945 +536 2 3.25022 9.8484 12.9226 -2.55555 -16.3803 0.657875 +537 2 3.7553 8.44758 13.4136 -17.8894 4.38499 -5.11642 +538 1 3.26012 8.5452 3.75851 7.68136 4.64814 -61.3797 +539 2 3.65213 9.34274 3.2957 -8.84339 -23.8918 18.3111 +540 2 3.19772 8.72964 4.66662 3.169 13.2307 40.2657 +541 1 5.70723 7.22602 8.61089 15.0471 5.15238 -9.7988 +542 2 5.61347 6.27934 8.4361 -3.3163 0.301479 7.52532 +543 2 4.97449 7.5436 9.15453 0.52499 -8.4302 1.10573 +544 1 14.8706 1.4621 1.8863 1.70998 27.5213 20.9307 +545 2 14.7201 2.23316 2.46749 -8.28585 -15.753 -0.675778 +546 2 15.5631 1.82311 1.33978 3.90729 -10.8233 -20.0391 +547 1 8.4891 15.095 0.746196 -1.67248 3.44686 2.60315 +548 2 9.16152 15.1411 1.43932 5.44244 -6.16758 -2.29782 +549 2 7.78914 14.5375 1.12422 -1.25934 1.00196 -2.01266 +550 1 15.531 1.37665 7.20033 20.0832 14.6351 13.3031 +551 2 14.8916 0.843079 6.76136 -18.4007 -14.9103 -14.8508 +552 2 15.066 2.19014 7.43626 -3.82192 3.26637 1.54172 +553 1 5.03616 12.9919 18.445 -16.5564 -3.92778 -1.34985 +554 2 5.49952 13.0651 0.633359 3.65082 -0.909975 11.8673 +555 2 5.58799 13.4788 17.838 5.35286 -1.67587 -4.32886 +556 1 15.4004 8.57696 18.1096 -13.5133 -17.3986 23.7812 +557 2 15.6963 9.177 17.4428 12.1428 17.8023 -17.443 +558 2 15.2132 9.11981 0.25138 2.83515 1.87454 -5.46736 +559 1 12.0742 3.0873 18.3015 -13.0771 12.9456 1.32203 +560 2 12.4416 2.71193 0.467697 5.19488 -4.15516 -6.31478 +561 2 12.3414 2.59119 17.5164 7.34103 -8.20972 9.84797 +562 1 13.1603 12.6784 5.14975 4.6094 5.88635 0.276196 +563 2 13.6665 11.971 4.72065 -1.49243 -3.38503 8.68718 +564 2 13.2851 12.6103 6.1136 1.29016 -0.295852 -5.09341 +565 1 6.06548 7.22062 0.130395 -10.0215 14.1887 -9.78073 +566 2 5.90478 8.1622 -0.126677 10.3505 -23.4507 13.8616 +567 2 5.20282 6.91875 0.452817 7.86884 -4.47391 0.318594 +568 1 17.6551 15.8705 14.9463 -5.31761 6.83655 -25.2986 +569 2 16.721 16.066 14.8837 -6.35164 3.20497 21.4179 +570 2 17.8286 15.8261 13.9944 18.3936 -6.902 3.79502 +571 1 13.1598 0.895115 16.6829 -10.2787 13.0231 -1.21317 +572 2 14.0985 0.838925 16.8484 11.7714 -2.60716 3.82434 +573 2 12.9094 -0.0108285 16.49 -7.09766 -5.67505 2.02872 +574 1 10.9245 14.5193 7.39494 -10.4099 -10.8827 23.6465 +575 2 10.1209 14.2503 7.91799 23.546 5.98273 -19.3945 +576 2 11.6246 13.8906 7.65805 -5.45953 8.29317 -8.96944 +577 1 17.5666 8.45977 2.1077 -2.45541 -18.4017 -7.84499 +578 2 16.6916 8.4078 2.54921 14.2221 -0.924117 -8.74119 +579 2 17.6058 7.68446 1.4828 -2.53767 24.5137 15.8214 +580 1 12.3693 7.85876 1.99742 11.9287 1.39128 11.652 +581 2 11.9574 8.70597 1.81668 -2.84663 4.1279 -5.57453 +582 2 12.0661 7.22941 1.33154 -5.87406 3.00715 -1.1515 +583 1 12.0244 14.6632 10.3909 28.0505 -1.98221 6.53788 +584 2 12.2154 13.9026 9.84664 0.841551 -5.23881 -6.52272 +585 2 11.0973 14.8027 10.3697 -37.2752 0.615569 -5.61626 +586 1 6.83101 6.95959 15.54 -26.922 -25.3261 -7.84618 +587 2 7.74646 6.93869 15.3131 28.0025 5.72032 -4.23149 +588 2 6.70706 7.70294 16.1074 0.47288 18.1258 13.2198 +589 1 7.99181 4.56873 13.323 -17.7662 10.8645 -2.94772 +590 2 7.11502 4.75523 12.8947 23.3848 -2.11675 2.9311 +591 2 8.34221 5.42155 13.6369 -8.03699 -10.5621 -3.57795 +592 1 13.4097 12.1854 14.3195 -5.65215 6.28756 1.83858 +593 2 13.0403 11.2921 14.2436 5.24433 -3.00833 -1.58816 +594 2 13.8498 12.3732 13.4771 -2.55607 -2.02901 -2.35573 +595 1 14.6454 9.43305 7.28195 10.7596 15.6461 6.41649 +596 2 15.5174 9.89596 7.36949 -20.7431 -7.51972 6.68313 +597 2 14.0059 9.84843 7.89782 12.5114 -5.65293 -10.9965 +598 1 12.693 16.9181 3.21868 4.13721 -47.3842 -7.97708 +599 2 12.7878 17.338 4.04875 4.47204 15.8163 32.4195 +600 2 12.4838 17.5994 2.61833 -10.0532 31.8516 -27.8744 +601 1 1.00841 7.13021 17.3596 12.9632 -6.47488 11.204 +602 2 0.140567 7.22584 17.7618 -2.41623 -7.13214 2.78808 +603 2 0.956632 7.61621 16.5408 -0.0488819 7.87685 -11.8994 +604 1 12.917 4.94058 15.6965 -33.9833 6.00302 -1.61153 +605 2 13.6432 4.4005 15.9475 28.608 -13.7192 2.54357 +606 2 13.1955 5.85458 15.7909 9.71851 9.87704 0.635703 +607 1 2.3887 3.3689 5.15584 14.955 -15.9692 -52.0278 +608 2 1.80093 3.08916 5.81858 -25.593 -10.9876 33.4797 +609 2 2.79381 4.15677 5.46164 14.8077 31.4017 13.6729 +610 1 8.27435 11.0395 13.6153 -37.0795 23.6732 -65.6931 +611 2 8.36475 10.9269 14.5167 14.9976 -12.7369 63.1872 +612 2 9.08207 10.7919 13.1709 13.5323 -11.5041 2.55762 +613 1 12.9711 1.50053 13.2758 -7.16838 -21.0368 21.1096 +614 2 13.525 1.50324 12.5105 16.6349 2.94139 -20.1138 +615 2 12.6114 2.3778 13.3258 -6.20414 13.0805 -2.33086 +616 1 6.55993 13.5741 2.17335 4.5265 3.63418 -23.4358 +617 2 5.93511 13.8533 2.83279 -12.7543 7.85744 13.7798 +618 2 7.20659 13.0527 2.65116 1.25385 -4.10852 0.808212 +619 1 15.8831 6.47501 12.6409 22.0814 4.72601 -0.603906 +620 2 16.4738 6.98335 12.028 -14.2245 -11.2946 14.6347 +621 2 16.3705 6.43226 13.5009 -10.5632 5.96191 -15.5708 +622 1 16.8031 0.705923 9.56407 -2.28595 11.5891 -8.26827 +623 2 16.6552 18.4511 9.84906 2.3526 -17.7501 5.98934 +624 2 16.3731 0.773302 8.69375 1.62838 3.03603 0.698224 +625 1 6.10625 11.6157 8.28914 -3.08711 55.9701 7.34602 +626 2 5.36711 11.2964 8.79127 -16.3164 -7.54559 6.80515 +627 2 6.5283 10.8686 7.94164 19.8706 -42.6353 -12.8098 +628 1 2.81358 8.70539 0.376179 36.8039 -5.08598 16.3747 +629 2 2.33554 8.23944 18.3571 -22.6922 -9.90678 -17.9478 +630 2 2.28148 9.42572 0.700092 -14.5476 7.98537 3.82577 +631 1 10.114 10.4289 6.56839 -5.48816 -6.21666 7.2072 +632 2 10.5648 9.70982 7.03635 1.99723 -0.0329781 -1.13968 +633 2 10.3487 10.347 5.64237 7.8387 0.67993 -6.97128 +634 1 6.81211 15.7679 6.65103 -0.348958 5.58939 -1.23617 +635 2 7.12762 16.1335 7.48534 -0.336507 -3.46393 3.99871 +636 2 7.12562 16.4168 5.9986 -1.75978 -6.48118 -4.29666 +637 1 6.49059 12.9347 5.74014 0.722488 11.3509 6.39713 +638 2 6.52544 13.8593 6.05125 4.61742 -7.45139 -3.43251 +639 2 6.13117 12.4341 6.48422 -0.637044 1.07223 -0.836688 +640 1 16.7722 12.5296 9.75372 -10.3378 8.80589 22.9139 +641 2 16.9709 11.8837 9.07779 5.41942 -3.21474 -11.15 +642 2 17.3199 13.309 9.62307 0.866334 -2.28521 -6.10033 +643 1 6.18734 2.89369 2.76381 6.70118 21.5641 -20.0406 +644 2 6.53969 3.77128 2.46465 -8.05809 -16.0544 14.4298 +645 2 5.6766 2.59589 1.99155 1.09601 -8.68373 7.94101 +646 1 10.8178 3.09588 3.24672 1.33393 -8.05069 0.148042 +647 2 10.2056 3.80475 3.46561 0.323029 3.07521 -1.63087 +648 2 10.3998 2.55919 2.55618 -0.935454 8.00813 2.52947 +ITEM: TIMESTEP +70 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.83052 6.78564 17.8747 4.81039 14.7119 7.93216 +2 2 8.02044 7.08583 18.306 -2.95347 -6.04078 -1.17349 +3 2 8.57794 6.09723 17.2713 -4.49598 -11.7014 -7.63976 +4 1 0.124161 8.31212 6.74558 -2.09679 -1.27724 -21.4903 +5 2 0.320991 8.02726 5.80661 -3.30063 7.0305 29.7013 +6 2 0.593986 7.72695 7.35611 1.84479 -1.64007 -4.64643 +7 1 8.55341 0.214487 6.89794 4.20955 -4.60902 11.3327 +8 2 9.45965 0.255338 6.58274 3.95615 -0.229119 -0.443755 +9 2 8.09377 0.850204 6.35793 -6.3823 8.35705 -5.64785 +10 1 6.52177 1.69631 11.7106 -29.0447 -4.52087 -3.66773 +11 2 5.85029 2.25877 12.1616 13.2184 -10.2105 -7.98022 +12 2 6.00884 0.936302 11.3174 15.6542 21.0994 14.986 +13 1 6.92822 5.5902 2.37948 23.4336 -17.8876 -5.1013 +14 2 6.5261 5.8779 3.18071 -18.514 8.45901 19.042 +15 2 6.74676 6.28055 1.75003 -1.36947 6.04298 -15.8103 +16 1 16.1916 10.2374 16.1412 -24.0328 -6.0953 4.14694 +17 2 17.0138 10.497 15.7581 19.6671 8.99174 -7.62884 +18 2 15.6617 11.0456 16.2513 11.6446 -5.87426 0.419849 +19 1 10.7179 14.9528 2.30402 9.26606 5.76352 20.4147 +20 2 10.604 14.349 3.06349 2.85769 5.88214 -5.84145 +21 2 11.1755 15.7297 2.69585 -5.79349 -8.7688 -7.8832 +22 1 17.1683 8.21322 10.7989 1.82063 -1.23871 -1.95171 +23 2 16.5117 8.80699 11.1832 -0.385781 3.51193 7.00123 +24 2 17.9642 8.75858 10.6912 0.976865 0.382705 -5.65698 +25 1 14.6466 15.9322 16.4418 -21.6809 -6.01765 9.50279 +26 2 13.7097 16.2329 16.4085 18.6708 -4.64396 -3.84163 +27 2 14.6751 15.3815 17.2568 4.92661 10.5457 -14.6576 +28 1 12.1005 13.348 0.567693 14.0677 -11.0124 3.49805 +29 2 11.7977 13.4785 18.3054 -3.25303 6.53047 -2.60123 +30 2 11.7369 14.0166 1.16546 -7.92056 -0.136763 -7.41856 +31 1 9.34615 5.48792 3.88275 21.7787 0.248377 2.40385 +32 2 8.84331 5.37966 4.67443 -9.14 -4.08483 27.4632 +33 2 8.65688 5.52523 3.23949 -14.702 1.76912 -26.3373 +34 1 1.6606 4.00652 11.6035 4.04251 -10.384 -6.17332 +35 2 1.67583 4.94617 11.8049 -2.44143 11.0832 5.72027 +36 2 2.2695 3.55993 12.2146 -3.92557 1.72629 -0.38872 +37 1 2.08139 6.85853 8.20375 5.25116 9.81515 7.60897 +38 2 2.56831 7.24635 8.96213 -7.90159 -5.93168 -10.5698 +39 2 2.00199 5.91426 8.39105 -0.650687 0.0621593 5.33933 +40 1 5.36768 4.45674 7.91405 -3.32795 5.87339 3.17518 +41 2 5.46396 3.51228 8.0104 5.66802 -14.4695 -1.12836 +42 2 4.78412 4.56623 7.16078 -4.98903 9.02084 -4.56071 +43 1 3.31193 2.91026 17.4243 5.25503 -22.5991 -0.535021 +44 2 3.97925 3.43469 16.9765 8.2555 0.833912 -8.18173 +45 2 2.82292 3.51814 17.9594 -9.74498 21.4045 11.9966 +46 1 7.44628 5.47686 6.16962 4.83779 4.18627 -38.8589 +47 2 7.80337 6.02378 6.84422 19.7966 19.2933 17.1246 +48 2 7.08839 4.74785 6.63594 -15.5951 -22.4752 14.0992 +49 1 9.79841 6.99298 12.0115 -14.4173 0.175621 -19.7413 +50 2 10.2338 6.25953 11.5352 -7.27244 10.6531 4.67439 +51 2 9.07403 7.33711 11.4082 20.5779 -11.7539 16.8314 +52 1 14.0932 3.73018 8.11294 -2.35225 21.206 2.79521 +53 2 13.7164 4.53948 7.70027 6.06412 -15.1972 7.35067 +54 2 14.2932 3.96864 9.04107 -1.96145 -2.4542 -11.4015 +55 1 4.4865 17.2305 3.91995 2.87421 -17.2964 21.8602 +56 2 5.37817 17.5632 3.85852 13.1015 6.2627 -4.15101 +57 2 4.01126 17.4425 3.12603 -6.70645 13.3364 -16.7923 +58 1 16.3503 16.556 10.4027 -28.8153 -10.9362 -6.11544 +59 2 15.5262 16.5238 10.94 14.5825 4.08322 -8.19499 +60 2 16.0782 16.1167 9.56389 6.69544 5.4961 14.7824 +61 1 2.00781 4.81695 0.19428 -16.7794 -3.94444 -13.379 +62 2 2.36068 5.21925 0.976813 15.1603 4.4174 16.1734 +63 2 1.77343 5.5764 18.2905 0.379182 1.41768 -5.2961 +64 1 11.3582 13.2716 16.3898 -3.93488 16.8957 9.12151 +65 2 10.9039 12.4355 16.5285 -2.10099 -6.82713 -1.65452 +66 2 11.9323 13.1324 15.638 7.04428 -4.38588 -8.74921 +67 1 10.1365 10.938 16.8467 -2.82235 24.3376 4.32555 +68 2 10.5718 10.0987 16.7812 6.05632 -17.4389 0.305733 +69 2 9.20542 10.7786 16.7086 -10.6888 -4.42603 -1.21793 +70 1 11.8139 17.4685 13.4625 16.8497 6.47801 1.45884 +71 2 12.3399 16.8066 12.9857 -2.09189 7.12722 0.625626 +72 2 12.305 18.316 13.3535 -13.8327 -6.90215 0.736174 +73 1 6.44924 9.38958 12.2401 6.69888 0.367183 -15.9058 +74 2 7.02028 9.14259 11.4734 -10.412 6.11649 20.9521 +75 2 7.00474 9.9221 12.8226 3.16796 0.0903621 -0.913647 +76 1 16.2861 12.8631 2.69282 -5.5095 27.1919 6.93721 +77 2 17.1297 13.3403 2.5399 -11.4064 -12.6315 1.20497 +78 2 15.6248 13.5969 2.82884 15.7371 -22.5818 -6.03687 +79 1 0.705842 12.6958 5.89372 11.1118 0.602373 24.8353 +80 2 1.18521 12.4959 5.09265 -4.47491 1.87676 -19.0631 +81 2 18.418 12.5564 5.72922 -11.8137 -1.703 -8.70405 +82 1 5.28198 16.3804 18.4185 -2.246 1.3069 9.83982 +83 2 5.62966 15.5825 18.0261 2.19299 -6.30074 -9.03385 +84 2 5.78103 16.4802 0.590407 -0.738213 6.24336 1.72583 +85 1 0.669378 7.71651 4.13384 -59.2278 -40.1014 26.2385 +86 2 0.0696389 8.03317 3.4616 -5.2936 5.59306 -12.1338 +87 2 1.48105 8.07531 3.93226 66.8664 27.2164 -22.0097 +88 1 3.17848 8.98449 6.48797 -11.6429 31.0556 -28.5774 +89 2 3.69754 8.52221 7.10624 17.5545 -20.4274 28.0681 +90 2 2.28321 9.06095 6.81713 -8.12873 -6.01142 5.66961 +91 1 7.27057 10.3561 16.259 12.8547 -0.986094 -7.05958 +92 2 6.52139 10.8488 15.9387 -6.88577 4.52419 -2.25862 +93 2 7.07809 10.1849 17.1799 -5.89204 -3.21212 7.89434 +94 1 11.0493 0.926342 5.00492 7.6282 -0.312775 10.2028 +95 2 11.2745 1.78939 4.63491 -8.49938 0.0964505 -4.50291 +96 2 10.791 0.378052 4.25157 -0.730025 2.38059 -0.222793 +97 1 4.31171 2.85627 13.1955 -2.92819 26.6809 -11.7177 +98 2 4.37585 3.38692 13.9969 4.42074 -3.40265 4.05123 +99 2 4.21422 1.95476 13.4751 -3.58996 -22.8444 6.9477 +100 1 8.4068 10.257 1.78795 4.04191 -13.9705 -5.37842 +101 2 8.26785 10.8775 2.49552 -4.14797 15.7472 11.4003 +102 2 8.5529 9.42866 2.25521 3.43453 -4.46737 -1.06154 +103 1 10.2803 1.70096 15.4762 8.76071 -4.61575 -1.32446 +104 2 11.1657 1.41822 15.7142 3.10462 2.167 2.36838 +105 2 10.3075 1.82832 14.5156 -8.33356 3.27592 2.91474 +106 1 2.63173 12.8085 7.89063 4.0959 -9.21484 -0.859497 +107 2 3.2295 13.3973 7.41028 -2.49756 4.22571 1.84267 +108 2 1.98308 12.5062 7.24287 -1.99659 4.67741 -0.497136 +109 1 3.82895 11.7184 5.01628 -2.65331 8.28036 11.6201 +110 2 3.66291 11.1157 5.74556 0.426771 -3.98214 -1.1075 +111 2 3.01542 11.7805 4.50368 -0.128738 -0.0731644 -2.81963 +112 1 6.76514 14.4734 16.965 3.61018 3.02569 -11.8589 +113 2 7.44445 15.1431 17.0872 4.2046 -3.50831 2.36163 +114 2 6.5725 14.4959 16.0119 -5.95898 4.08629 6.49151 +115 1 14.2172 14.5156 3.23512 -15.7654 4.80027 20.0484 +116 2 13.9157 15.4376 3.23841 -0.320177 -6.15912 -4.56224 +117 2 13.7912 14.1249 4.0321 9.04818 0.126488 -15.8424 +118 1 8.62194 18.1001 16.0659 -23.21 2.71751 -2.03066 +119 2 9.16623 17.3958 16.3546 8.59431 -35.107 8.94544 +120 2 9.24682 0.159724 16.0687 7.59352 33.2076 -10.3682 +121 1 4.64785 1.66473 4.88429 20.0976 -32.3539 12.8345 +122 2 3.91841 2.23972 4.98678 -27.2909 21.6553 1.42112 +123 2 5.29938 2.12424 4.3745 8.75708 11.4615 -15.3566 +124 1 14.996 12.6195 16.4803 11.4842 8.30008 2.93566 +125 2 14.5677 12.8295 17.3315 -5.03395 -0.949445 -14.8823 +126 2 14.3989 12.5973 15.7101 -8.95177 1.91572 10.2236 +127 1 15.728 18.434 16.8656 -21.8007 21.3443 -35.9839 +128 2 16.2692 18.4514 17.6234 28.2096 -0.560819 33.2727 +129 2 15.2446 17.617 16.9069 0.184765 -20.6285 -2.2654 +130 1 1.36479 1.27889 16.6468 -16.7944 -10.044 -5.49533 +131 2 2.14801 1.79564 16.8219 8.14362 6.44014 2.70449 +132 2 0.693336 1.65446 17.2331 2.17778 -0.49248 0.882874 +133 1 18.205 4.38071 15.9717 -12.5383 1.08179 -4.34425 +134 2 17.9247 3.87865 15.1967 2.33887 0.121173 2.56773 +135 2 0.514445 4.3883 15.9876 8.17504 0.178033 -1.34417 +136 1 12.1632 17.0104 16.1415 17.8243 8.47052 -8.26904 +137 2 11.4339 16.4838 16.4748 -11.8796 -0.396392 0.7857 +138 2 12.1013 17.0682 15.1696 -12.6199 -2.93135 7.53111 +139 1 16.1201 2.6287 18.1864 3.80406 -3.99791 19.9987 +140 2 15.7935 3.50022 18.4009 -8.69312 10.1277 7.25942 +141 2 15.8264 2.47036 17.3057 -5.74882 -3.05042 -27.5508 +142 1 6.63908 13.8237 10.1059 1.54133 -19.2408 -0.896874 +143 2 6.60488 13.4547 10.9999 -2.4531 4.12781 1.41157 +144 2 6.6237 13.027 9.53669 -1.978 12.9815 -0.0933135 +145 1 10.1367 18.5192 2.71126 14.9692 1.08893 5.4249 +146 2 10.5375 0.290475 1.93143 -3.72697 -2.23961 5.76435 +147 2 9.31873 18.1319 2.42821 -14.2623 -5.70844 -7.57952 +148 1 3.05388 17.7183 6.14163 -17.3097 -9.85118 -22.5426 +149 2 2.24205 17.5791 5.58071 14.4512 3.50974 23.581 +150 2 3.73807 17.7208 5.46344 2.0394 5.03095 2.09251 +151 1 12.6118 16.8054 7.95495 4.58219 1.15158 -10.9791 +152 2 11.8555 16.2225 7.90842 -7.26482 -13.9478 -6.78863 +153 2 12.3849 17.4156 8.64585 -0.135632 15.5831 16.1371 +154 1 14.8975 15.2817 8.22586 -10.0433 25.2404 1.15436 +155 2 14.1016 15.8482 8.35876 13.2826 -12.9576 -5.35538 +156 2 15.2902 15.6258 7.39629 -1.79461 -13.1873 12.9757 +157 1 17.8242 18.245 0.290753 35.0262 5.69882 -22.3559 +158 2 18.562 17.7688 18.4584 -26.5201 3.44978 21.3008 +159 2 18.2553 0.461923 0.458274 -15.0979 -6.94564 5.00195 +160 1 0.811942 10.4929 1.40956 8.77271 16.3938 -17.0751 +161 2 0.0922351 9.87336 1.50209 -12.9574 -8.99075 8.33498 +162 2 0.506251 11.1761 0.770938 6.09002 -9.92994 11.4815 +163 1 1.80057 12.2567 3.3157 -0.00821892 -5.58838 -28.0373 +164 2 1.51905 11.5718 2.65287 2.57103 10.7079 19.8708 +165 2 2.13035 12.9839 2.7472 -5.7627 -4.92842 11.1942 +166 1 0.668516 17.2609 4.94683 -35.85 3.98858 25.1078 +167 2 0.0697466 18.0029 5.19004 17.5579 -5.46754 -17.9658 +168 2 0.309089 16.5456 5.51301 20.6369 3.3795 -13.3957 +169 1 1.1258 0.902495 9.33726 -12.4564 -3.06084 39.8122 +170 2 1.2842 0.722879 10.3134 -2.51149 4.27857 -26.5162 +171 2 0.280567 0.461704 9.18062 1.78742 1.97705 -4.09399 +172 1 16.751 2.38387 13.3212 3.93571 18.018 2.1702 +173 2 16.8889 2.64612 12.3995 3.13812 2.89192 3.07637 +174 2 16.5572 1.45381 13.2916 -4.67688 -18.3777 2.25645 +175 1 2.721 15.8932 12.0356 -10.4038 6.64935 25.1991 +176 2 2.99704 15.5189 12.8835 -2.56405 3.43208 -4.36032 +177 2 3.3254 15.553 11.3859 5.26998 -2.53603 -11.8474 +178 1 16.4132 15.6174 6.13158 -30.6236 -31.2218 7.18947 +179 2 17.2889 15.5331 6.46785 25.936 1.45578 4.51193 +180 2 16.388 16.3213 5.51027 2.55474 24.6255 -21.834 +181 1 5.75165 5.17156 11.8076 -10.0158 20.8309 8.83951 +182 2 5.58328 6.03799 12.2608 0.394348 -20.1746 -10.5178 +183 2 4.95414 4.6515 11.9927 8.5068 -2.87995 -2.26002 +184 1 15.1308 4.87532 0.804768 27.2949 -1.75024 -19.8676 +185 2 14.8777 4.72649 1.70618 -7.53991 -8.08598 20.9925 +186 2 14.4372 5.36761 0.397065 -18.333 11.5318 -5.57633 +187 1 16.3608 16.424 1.96087 0.545069 28.5814 -7.81874 +188 2 15.9402 16.8572 2.72963 9.40909 -7.94755 -2.88814 +189 2 16.7928 17.1706 1.4719 -7.75465 -17.4072 6.82817 +190 1 0.195497 4.8427 3.9016 -20.8114 -16.3238 -7.36148 +191 2 0.347935 5.77048 3.88737 2.90582 31.823 0.953261 +192 2 1.01225 4.48793 4.21241 18.9183 -15.2676 9.08502 +193 1 2.99687 15.0761 15.1729 -7.80035 25.004 -19.9303 +194 2 2.75027 14.6107 15.9518 -1.28992 -16.7566 29.7079 +195 2 2.55205 15.9391 15.3182 6.19364 -5.6546 -9.94962 +196 1 1.13925 14.6508 9.53021 19.9076 23.5081 3.98588 +197 2 2.07639 14.8825 9.77663 -29.323 -13.131 -7.88186 +198 2 1.04812 13.6993 9.55892 5.54263 -6.82879 4.76298 +199 1 13.5171 16.5199 11.5195 20.4201 8.76324 22.1576 +200 2 12.9867 17.257 11.2155 -0.855064 7.64635 -14.0191 +201 2 13.0442 15.7467 11.2378 -7.08331 -12.4379 -10.7884 +202 1 4.66723 1.48136 0.73322 23.0149 3.26353 10.1864 +203 2 3.99044 1.945 0.247475 -7.51763 5.99594 -9.81004 +204 2 4.21698 0.879204 1.33273 -6.6714 -6.19828 -5.18082 +205 1 1.48126 18.5865 11.8932 5.77456 11.9109 13.6761 +206 2 1.45047 0.509997 12.7065 -0.655319 -12.4833 -18.3988 +207 2 2.16842 17.9125 12.0331 -8.54366 2.69761 2.01722 +208 1 11.4638 10.1444 4.04596 -29.9846 -9.43843 22.7531 +209 2 11.586 10.5695 3.21678 -1.49335 12.1472 -28.3165 +210 2 12.3366 9.99459 4.35585 30.6386 -4.62302 8.08877 +211 1 8.15809 12.1698 3.75544 16.5318 -12.8496 -25.3624 +212 2 9.0168 12.5594 3.97136 -0.0903232 2.9732 11.2136 +213 2 7.55758 12.2779 4.48666 -4.55936 7.15494 21.2951 +214 1 14.57 4.03338 3.33424 -15.9396 -3.34089 -13.9779 +215 2 15.2475 4.30951 3.93522 14.2067 0.133456 17.245 +216 2 13.7488 4.35662 3.71839 -4.37522 2.77806 -1.52286 +217 1 5.69573 1.64484 7.55416 47.4861 32.5669 -28.9041 +218 2 5.02314 1.22164 8.01158 -49.1519 -34.4826 29.3881 +219 2 5.51675 1.48645 6.61188 -4.44278 2.0561 3.75596 +220 1 17.8757 1.08291 4.8338 -2.11434 0.172647 4.71576 +221 2 18.4455 1.46692 4.16357 3.67184 -2.89676 -9.33974 +222 2 18.0165 1.6381 5.60499 -0.396504 -0.0112538 6.48923 +223 1 6.85338 9.35555 4.52322 8.01303 -7.73923 12.5712 +224 2 6.71294 9.49068 5.48294 3.02765 -1.76203 -13.5451 +225 2 7.79052 9.06961 4.44068 -13.079 3.18293 -1.46589 +226 1 2.62197 14.8521 2.02937 -10.5221 3.39156 -23.0918 +227 2 3.43005 14.7674 2.51892 12.1264 -2.78802 16.39 +228 2 2.89555 15.1253 1.13827 -2.73698 -5.91865 10.4405 +229 1 17.3299 12.9421 13.1931 -12.7738 17.025 -7.03447 +230 2 16.4383 13.2606 13.4479 14.3464 -2.45707 -5.73497 +231 2 17.7945 13.7546 12.8897 -6.22536 -14.4165 5.27249 +232 1 14.8979 10.5619 1.48982 -11.9525 28.8063 14.5441 +233 2 15.3485 11.4081 1.81139 -13.0513 -30.8314 -8.90843 +234 2 13.9324 10.6539 1.67123 25.3412 1.8999 -4.23485 +235 1 5.67595 6.67872 4.55433 0.362155 18.5292 -10.9955 +236 2 5.7867 7.61135 4.29326 0.453279 -5.37291 7.09585 +237 2 6.40948 6.48302 5.14674 -0.086512 -6.41659 5.49044 +238 1 7.99316 8.32936 10.3099 -9.88556 -13.348 -36.673 +239 2 8.52429 8.77949 9.6279 3.30308 5.35046 16.0689 +240 2 7.32365 7.86355 9.75728 7.50693 2.48224 14.219 +241 1 13.4328 18.4778 5.70681 16.0844 -0.193399 -6.38488 +242 2 12.6986 0.421386 5.55211 -13.5651 7.65576 -7.58054 +243 2 13.084 17.8957 6.37412 -0.0453673 -15.2248 15.7361 +244 1 -0.0111344 2.60704 0.305045 25.2129 -30.2702 8.72131 +245 2 17.7164 2.72495 0.164021 -32.2143 -6.6311 -9.93678 +246 2 0.303096 3.48034 0.225751 24.1306 33.5707 -2.06333 +247 1 12.8325 10.9421 9.75806 8.08682 -36.6012 3.93532 +248 2 11.88 10.8422 9.79419 -10.8426 11.3849 -4.95145 +249 2 13.0795 10.0004 9.94273 0.259667 22.5692 -5.0531 +250 1 0.642026 12.1683 11.0609 4.45464 6.09796 -5.6804 +251 2 18.3356 12.2213 11.2584 6.06715 1.14224 4.76964 +252 2 1.15053 12.4132 11.8471 -8.72956 3.82018 2.8882 +253 1 5.19121 7.35128 13.362 14.2217 -1.26987 2.88721 +254 2 5.71731 8.09811 12.9969 -6.96977 -10.5111 6.72344 +255 2 5.67215 7.04852 14.1611 -4.50302 8.90065 -9.08298 +256 1 1.17753 6.82665 11.884 -6.96202 23.1207 3.27017 +257 2 0.332868 7.13942 11.4836 19.3553 -6.8941 9.30012 +258 2 1.59694 7.61812 12.3119 -7.65201 -17.5731 -13.8958 +259 1 15.4801 9.74186 12.3501 8.02403 -36.537 -7.5848 +260 2 15.2771 10.6331 12.1319 -8.61126 25.0623 0.312061 +261 2 15.6595 9.70704 13.2832 1.37326 2.5629 11.9963 +262 1 16.5169 12.594 5.50965 10.4637 -15.548 10.5874 +263 2 16.3074 13.4879 5.77305 -4.76715 16.3332 -4.64473 +264 2 16.4013 12.5274 4.55501 -3.26126 3.70708 -8.86796 +265 1 6.31292 9.82321 0.0853393 -0.254663 19.8779 15.0366 +266 2 5.47299 10.2624 0.316114 7.63969 -1.93852 0.671735 +267 2 6.95815 10.0698 0.784254 -6.58085 -1.04763 -9.09577 +268 1 12.2316 6.09819 4.0135 -11.5327 11.7492 -3.18772 +269 2 12.1819 6.93481 3.49894 6.0574 -18.2652 4.97925 +270 2 11.3139 5.7855 4.02535 4.75129 -2.10791 -0.415098 +271 1 0.346102 12.8439 0.0895734 -4.86896 0.353582 5.39062 +272 2 18.7507 13.4631 0.799834 -0.48412 -1.67542 -1.66039 +273 2 18.3682 13.0274 18.0218 -2.69393 2.08889 -5.2677 +274 1 3.5489 0.022651 8.64264 14.8213 -2.21723 6.15117 +275 2 3.34146 18.2537 7.79412 -1.37888 1.54429 -1.85278 +276 2 2.69807 0.312924 8.99074 2.91061 0.134312 -8.36673 +277 1 7.48275 17.4677 4.49597 -9.82961 -11.4008 2.47905 +278 2 7.76172 18.3639 4.65831 -0.473756 11.2371 0.709742 +279 2 7.61951 17.3416 3.55584 -1.72206 -2.44101 -5.98946 +280 1 9.27482 17.1419 12.2002 -29.9673 17.8198 -3.75997 +281 2 9.29449 16.2474 11.8858 2.76409 -17.0257 -9.00951 +282 2 9.96887 17.232 12.8306 24.004 1.27191 14.3563 +283 1 13.3881 13.0638 7.94543 23.8544 1.05207 16.0454 +284 2 13.4911 12.3591 8.61055 -7.80977 1.42534 -8.25381 +285 2 14.1677 13.6583 8.10929 -22.3675 -6.64423 -7.05202 +286 1 14.8196 2.98416 15.4059 10.9247 4.82989 11.3692 +287 2 14.1977 2.30622 15.182 -14.8004 -11.8419 -2.86461 +288 2 15.3715 3.04555 14.6288 11.3419 0.403673 -8.50968 +289 1 9.89007 15.644 16.9507 -0.476448 -13.1737 2.9886 +290 2 10.2689 14.811 16.6236 0.33136 1.14394 -2.50282 +291 2 9.50974 15.3862 17.8064 -0.51987 6.75584 -0.702029 +292 1 11.2404 8.49746 16.6126 -11.0388 -24.1902 -5.6141 +293 2 10.5493 7.95233 16.1656 11.7734 11.5748 6.95591 +294 2 11.5411 7.95338 17.3605 -0.459906 4.27214 -6.12679 +295 1 3.94653 18.1828 16.8275 -12.5536 19.575 -10.0724 +296 2 4.49583 17.6028 17.3635 4.26127 2.6886 8.36922 +297 2 3.95977 0.456308 17.1729 5.72776 -19.9128 0.46306 +298 1 2.2132 4.22212 8.91052 -3.52394 3.62108 -17.0138 +299 2 3.14576 4.09878 8.74947 8.67559 -2.34434 0.767855 +300 2 2.06536 4.03466 9.83165 -0.817379 -1.75645 17.2153 +301 1 9.87247 10.3712 9.74928 14.7683 -30.296 -5.49075 +302 2 9.62147 11.2221 9.45607 -13.6864 32.2476 -14.4563 +303 2 9.99394 10.4206 10.6874 0.365841 -1.43755 21.5864 +304 1 9.68376 0.92477 10.8522 -9.86416 -7.8375 -9.37303 +305 2 9.18791 0.169256 11.2055 11.1043 -0.796798 3.35444 +306 2 9.09399 1.23638 10.1435 10.2069 6.90097 4.69651 +307 1 9.16769 15.091 10.1956 22.4355 7.87639 6.21774 +308 2 8.9696 15.9691 9.88131 -3.17938 11.9605 -8.33522 +309 2 8.32743 14.6622 10.1389 -19.5916 -16.662 -1.08184 +310 1 0.85922 9.69743 10.2442 32.6336 -47.5631 -25.4673 +311 2 1.02374 10.6105 10.3992 -2.53948 25.7241 9.50189 +312 2 1.72313 9.35148 9.87448 -35.4256 9.68482 16.6576 +313 1 17.0256 4.81986 8.08308 31.6348 -31.2729 -9.48192 +314 2 16.3215 5.37214 8.33224 -31.3655 27.4802 10.3117 +315 2 16.9319 4.0155 8.6004 0.768816 2.34372 -1.45333 +316 1 14.8081 14.6794 0.153243 -2.85725 -11.5952 -11.9613 +317 2 15.2092 15.2804 0.771003 11.383 9.73034 15.7651 +318 2 14.0408 14.3115 0.591288 -7.92269 -3.99881 6.06231 +319 1 3.80416 11.0019 9.56526 0.623941 6.68377 2.11405 +320 2 3.77619 11.4642 10.4186 -0.043788 -6.16761 3.62327 +321 2 3.31763 11.5705 8.95624 -4.54045 6.84371 -3.4313 +322 1 11.3158 10.7476 1.45776 10.9951 -9.43983 2.74041 +323 2 11.5252 11.5694 1.01773 6.8042 14.5185 -3.76913 +324 2 10.3718 10.6573 1.35733 -14.9091 -3.38451 -2.45366 +325 1 13.1832 7.19978 12.6897 5.92706 -14.8401 5.32281 +326 2 14.1145 6.87754 12.7085 -13.0936 9.37511 -3.26372 +327 2 12.6462 6.38983 12.7968 5.91866 7.22274 -2.53959 +328 1 9.61767 1.88189 0.936979 -6.6056 8.12678 -33.3335 +329 2 8.75647 1.76915 0.468433 15.5153 -2.73343 13.4493 +330 2 10.2273 2.17983 0.230861 -6.38326 -0.489196 14.1696 +331 1 10.6523 13.47 4.56634 -17.7163 6.61907 -5.84307 +332 2 11.5562 13.1849 4.68206 11.5009 -9.86279 4.07703 +333 2 10.5151 14.0877 5.29021 -1.44258 0.681598 7.9468 +334 1 14.5213 1.69385 10.9785 0.412416 12.5139 1.3055 +335 2 15.3159 1.33414 10.5754 1.96072 -4.24727 -0.900333 +336 2 14.7412 2.63918 11.0728 -6.13642 -3.41388 -3.76294 +337 1 14.5042 12.0777 11.6111 -12.2061 0.510996 31.5423 +338 2 15.1827 12.4648 11.0978 29.2487 15.6657 -21.0239 +339 2 13.909 11.6953 10.9807 -16.843 -4.29027 -12.6849 +340 1 8.18401 5.11068 9.87002 -0.676892 -7.65738 -3.35075 +341 2 7.33939 5.06675 10.3357 0.521056 4.21206 1.1001 +342 2 8.29842 4.21721 9.50312 -0.00697362 5.6522 3.71152 +343 1 1.5768 16.9623 18.4443 13.7844 -6.06932 -11.1938 +344 2 2.08688 17.3314 17.6994 -1.29344 -1.55823 6.9248 +345 2 1.72478 16.0021 18.3853 -4.19272 5.84443 -4.03385 +346 1 1.47359 17.3466 15.3156 -41.3862 18.9515 21.4522 +347 2 1.38751 18.1942 15.8376 11.356 -22.4463 -17.1221 +348 2 0.531998 17.0202 15.2731 27.9598 4.08453 -2.72162 +349 1 3.56251 5.80266 6.06315 1.23781 -30.1986 0.952301 +350 2 2.9922 6.42371 6.50913 -3.22231 11.6367 6.59476 +351 2 4.22501 6.28135 5.5614 1.05528 7.23928 -6.44245 +352 1 12.5723 9.4951 14.2463 -14.1947 49.7353 4.36555 +353 2 12.9086 8.77822 13.7576 17.8642 -40.1771 -16.3075 +354 2 12.2963 9.16979 15.1004 -1.36164 -11.5003 11.0357 +355 1 4.07044 15.2648 6.99086 -8.22484 -15.5272 10.3185 +356 2 3.65725 16.0904 6.74002 -9.77102 8.77549 -2.61135 +357 2 5.00026 15.4315 6.88928 20.0063 2.47059 -3.54324 +358 1 0.744606 8.73408 15.0763 0.0218964 -5.95646 -3.10884 +359 2 0.519262 9.66197 15.1074 -7.84082 12.7234 2.89932 +360 2 1.47025 8.73132 14.4431 5.87969 -4.51966 -2.6491 +361 1 12.9306 8.27919 10.1905 8.08936 2.40022 19.7343 +362 2 13.779 7.90886 9.87037 -9.22858 -4.32337 9.26771 +363 2 12.8604 8.07471 11.1624 7.69549 -2.50096 -25.1681 +364 1 15.3235 7.85492 3.5497 18.4153 32.411 -54.1913 +365 2 14.4745 7.6657 3.15314 -16.0822 -13.4855 9.94503 +366 2 15.5116 7.64082 4.44166 -12.2255 -21.7424 34.152 +367 1 17.2256 6.71185 18.6385 13.0601 3.46678 -1.24204 +368 2 16.7837 5.9846 0.423329 -10.4159 -11.046 2.92977 +369 2 16.5307 7.32814 18.3852 -6.78357 2.8142 -3.2779 +370 1 8.8964 6.96848 7.83902 16.0931 16.0227 -2.80611 +371 2 9.83265 7.28699 7.8278 -17.1093 -4.77101 0.707558 +372 2 8.79691 6.46408 8.64714 -0.939429 -8.3316 9.69843 +373 1 12.4084 0.523138 1.23768 -2.06115 0.0733923 -7.11266 +374 2 13.1872 0.998726 1.54472 7.23891 -2.91784 -1.02165 +375 2 12.4662 0.537618 0.274809 1.69654 -3.93261 2.5223 +376 1 5.65468 15.0902 14.5334 3.02676 -25.5773 -0.125585 +377 2 4.72407 15.1616 14.7961 0.127409 2.72757 -0.91443 +378 2 5.99013 15.9712 14.3886 3.52657 16.2654 -6.40367 +379 1 3.82399 6.39797 1.75512 3.78691 -6.14258 3.26006 +380 2 3.37829 7.15763 1.38654 -6.41374 16.3556 -5.84968 +381 2 3.97609 6.61981 2.67876 -1.82166 -0.0414506 2.69272 +382 1 3.91801 11.4637 12.3808 6.26728 1.11409 -8.60855 +383 2 4.78798 11.8777 12.4982 -7.30712 -3.21292 -1.54071 +384 2 3.30212 12.087 12.775 -5.64928 0.778082 5.20377 +385 1 5.29676 3.85177 15.8189 3.43828 -31.27 -8.27082 +386 2 6.03967 3.23378 15.6029 -11.8461 12.1043 0.727598 +387 2 5.68429 4.70341 15.931 13.0054 23.274 1.41344 +388 1 14.2193 10.1559 4.56622 -21.9238 17.9967 10.7876 +389 2 14.2923 9.81422 5.45847 5.67938 -3.41822 10.3914 +390 2 14.6614 9.51741 4.03067 14.2685 -12.4061 -15.9356 +391 1 7.6994 17.3598 9.13069 2.58566 -7.07749 -1.38218 +392 2 6.9688 17.7373 9.6086 -11.208 -1.02501 12.7072 +393 2 7.91331 18.0249 8.47917 9.78731 5.09099 -13.1281 +394 1 4.50671 14.5226 3.97805 12.528 -25.4608 -46.8355 +395 2 4.48015 15.4086 4.24602 -0.161492 47.21 12.2969 +396 2 4.35306 14.022 4.74858 -6.07017 -24.5156 30.0525 +397 1 14.1411 7.46132 15.8217 -22.5264 -9.25347 -2.17647 +398 2 14.9826 7.35759 15.4044 20.5288 -0.540355 -7.58788 +399 2 14.3421 7.83921 16.6731 3.72262 6.08742 11.7763 +400 1 2.98184 18.372 1.90579 -20.1648 -30.237 -17.2141 +401 2 2.43548 17.7555 1.32026 19.5303 24.385 16.7936 +402 2 2.33791 0.236975 2.41065 -5.95562 0.980031 -0.0237849 +403 1 7.99445 1.58502 4.53075 18.7977 0.504684 -14.6733 +404 2 7.48712 1.99417 3.8192 -9.17378 0.780153 1.87786 +405 2 8.88078 1.50473 4.13387 -7.12077 1.17171 10.2984 +406 1 2.41951 14.1599 17.7056 22.0207 15.2121 -4.13121 +407 2 1.68443 13.6195 17.9516 -15.3327 -12.8663 8.26013 +408 2 3.18525 13.6986 18.0793 5.57496 -0.0710026 -2.65101 +409 1 0.908587 1.85846 13.8858 -0.0793858 -1.94323 14.6669 +410 2 1.14821 1.59902 14.7928 -3.46921 3.66635 -7.67361 +411 2 18.5942 2.00299 13.9058 4.01903 -0.250224 -6.72878 +412 1 4.32702 0.129386 13.8829 -0.0770511 3.08332 3.55447 +413 2 5.24833 18.5067 13.8286 4.90059 -4.64875 -2.30826 +414 2 4.05486 18.5232 14.7746 -2.81766 -1.27361 1.32354 +415 1 7.27357 0.854459 18.3804 -15.3869 4.3045 -1.1218 +416 2 7.16992 0.518993 17.4624 3.36336 5.55626 15.3605 +417 2 6.40185 1.20099 18.6914 11.5657 -10.6186 -10.5297 +418 1 15.9542 18.4046 13.9208 -25.3022 5.029 -14.7602 +419 2 15.0075 18.5254 13.735 13.8644 -2.42428 -4.09563 +420 2 16.0061 18.5076 14.8614 8.67486 -1.51607 21.0166 +421 1 10.2392 4.55204 16.2801 10.7238 -8.25817 -3.6178 +422 2 11.196 4.37813 16.4864 -24.802 4.89259 -9.76699 +423 2 9.86858 3.73489 15.891 10.2726 5.88423 10.0044 +424 1 15.9238 17.7149 4.45644 2.75189 -23.1215 -12.8271 +425 2 16.5168 18.4535 4.47728 14.6813 18.6917 2.39924 +426 2 15.0936 18.0469 4.76398 -21.0845 8.87368 10.3462 +427 1 6.95648 17.503 13.9077 -51.9825 -4.38955 -3.71365 +428 2 7.39002 17.773 14.6913 25.8751 9.72049 29.5532 +429 2 7.60747 17.4983 13.2335 27.2317 -2.92469 -23.3456 +430 1 13.2071 6.48879 6.54043 12.3601 -8.29587 -18.0485 +431 2 14.1818 6.5258 6.42811 -17.7974 6.95191 3.55269 +432 2 12.8555 6.35956 5.62691 5.37067 1.68412 18.5111 +433 1 7.86742 2.30794 9.39626 -5.35093 5.07188 8.74379 +434 2 7.30782 2.2926 10.1983 5.67726 -4.12754 -5.74363 +435 2 7.33716 1.92062 8.69482 -5.03183 0.0809058 -6.36949 +436 1 15.2078 14.7586 13.7432 0.832397 -4.30074 -2.87903 +437 2 14.8858 14.9257 14.6258 -3.94452 3.16733 11.6107 +438 2 14.9517 15.5204 13.2236 -2.78606 2.09491 -5.66724 +439 1 9.4202 8.34719 3.8485 -22.8652 4.71801 -4.87246 +440 2 10.1988 8.89706 3.87201 15.3465 4.97444 3.28263 +441 2 9.69606 7.44575 4.01411 1.53448 -7.03017 -1.02937 +442 1 17.7384 13.5884 16.4052 -11.7067 -11.536 8.32036 +443 2 16.7673 13.5542 16.377 3.38001 -6.87595 1.27552 +444 2 17.9496 14.385 15.9274 3.88108 14.0768 -7.71607 +445 1 4.90559 10.5521 2.87839 21.3367 -20.8737 -11.4011 +446 2 5.623 10.1254 3.38432 -4.07258 6.62764 -8.01418 +447 2 4.62886 11.2624 3.4373 -4.18877 12.0113 9.86562 +448 1 3.72998 8.3995 9.96949 0.206562 0.552242 5.18998 +449 2 3.80623 9.33185 9.71276 -0.050758 -4.34606 1.0469 +450 2 3.86748 8.41721 10.9275 -4.36654 -3.13592 -2.04235 +451 1 15.965 6.95365 5.95266 -6.26742 1.66997 1.55481 +452 2 16.7698 7.37181 6.25298 11.0034 6.69643 7.83926 +453 2 16.2161 6.06091 5.70554 3.02292 -8.38979 0.185448 +454 1 15.1879 7.19538 9.00463 -16.574 -33.0638 16.9279 +455 2 15.9728 7.55664 9.38717 21.7076 13.0833 8.35481 +456 2 14.9649 7.65827 8.21955 0.87619 20.3483 -26.3308 +457 1 6.20656 12.8742 12.7233 -2.45823 6.18764 -5.3718 +458 2 6.79799 12.2543 13.1384 18.4055 -9.75357 3.10315 +459 2 6.13621 13.6122 13.3363 -4.91508 8.57981 5.63651 +460 1 12.128 4.53555 13.1062 -17.5662 -8.78193 22.9206 +461 2 12.3906 4.63486 14.0411 2.44404 0.930561 -9.75427 +462 2 11.3004 4.01263 13.1714 14.0583 8.15169 -11.9376 +463 1 11.4184 8.10098 7.95437 7.14359 -3.91624 -16.2991 +464 2 12.1028 7.60478 7.4673 -7.16754 1.39876 -0.578178 +465 2 11.8093 8.18067 8.82553 -2.79742 2.89488 8.77133 +466 1 17.0514 10.8651 7.58728 -24.1088 0.784299 26.3012 +467 2 17.8144 10.3384 7.41217 20.5663 -15.9736 -11.9321 +468 2 16.8601 11.4269 6.84052 2.19633 6.48519 -17.1676 +469 1 5.231 18.0993 10.8546 26.455 4.8965 -4.82813 +470 2 4.8195 17.6908 11.6007 -11.7048 -9.88744 14.1218 +471 2 4.63699 18.0004 10.1206 -18.4061 3.17503 -16.8763 +472 1 7.59767 17.4436 1.69759 5.72815 6.19172 -16.2775 +473 2 7.89477 16.6568 1.18579 0.971667 15.0969 7.35096 +474 2 7.65141 18.2352 1.10536 -4.88626 -20.2664 5.47735 +475 1 1.93145 12.9234 13.6206 5.60545 -3.12143 -21.3855 +476 2 1.4749 12.3281 14.2061 -8.56587 -7.9862 10.2726 +477 2 2.17547 13.6903 14.1341 4.19375 11.0678 7.71152 +478 1 9.43748 6.79443 14.8327 33.0335 -30.4644 -7.71462 +479 2 9.91196 6.01751 15.25 -19.5648 18.6507 -3.60269 +480 2 9.7502 6.76156 13.9011 -9.65438 10.9618 10.9707 +481 1 15.2831 4.34212 10.7772 21.179 15.7439 -2.01388 +482 2 16.2293 4.27243 10.5111 -19.8675 -5.23 11.4528 +483 2 15.2971 5.09975 11.4021 -5.00612 -14.3562 -6.14057 +484 1 11.351 6.2072 0.109577 23.6613 28.7979 6.66193 +485 2 11.4872 5.27024 0.0694097 -6.21323 -21.6319 -6.22108 +486 2 10.4676 6.44004 18.4761 -18.3883 -9.25121 -2.88973 +487 1 18.5357 11.4228 14.9398 26.7643 -26.8403 31.1109 +488 2 18.0597 11.723 14.1947 -18.2778 17.0129 -29.9513 +489 2 18.4532 12.1424 15.5699 -5.23995 5.81903 4.32114 +490 1 7.05668 9.28071 7.31234 -6.58466 7.4517 -4.55549 +491 2 6.71011 8.47084 7.6978 -4.31789 -6.13087 1.68327 +492 2 7.98804 9.13135 7.18438 15.6823 -2.37616 0.276954 +493 1 18.324 15.3331 12.2569 -7.46978 -1.64803 5.36971 +494 2 0.564477 15.5946 11.9899 10.9599 1.36641 -5.51497 +495 2 17.7284 15.6281 11.5548 0.957946 6.58656 -2.69515 +496 1 16.4958 4.38611 5.25998 2.69003 14.057 -30.634 +497 2 16.6253 3.88668 6.0538 7.32023 -9.57738 16.711 +498 2 17.3371 4.41488 4.75201 -4.14044 -1.60108 11.4247 +499 1 17.7073 3.15256 10.779 -3.63642 -2.40486 -9.15002 +500 2 18.6235 3.40441 10.9111 8.43018 2.88916 7.88185 +501 2 17.7389 2.35032 10.2471 -2.89329 -5.91517 0.580451 +502 1 12.2813 18.6401 10.1181 2.89516 -35.5496 -8.35074 +503 2 11.4703 0.383955 10.4005 -29.8535 10.9583 6.97968 +504 2 12.9196 0.674429 10.2218 25.4798 25.6209 2.989 +505 1 10.3974 9.74216 12.5073 0.112101 -17.0368 -3.21727 +506 2 11.1947 9.82557 13.039 4.39701 4.68697 5.66162 +507 2 10.3035 8.76836 12.4158 -2.37231 15.8308 -1.56525 +508 1 0.663588 2.73535 7.12598 -12.3374 1.53361 -6.62113 +509 2 0.367817 3.62684 7.37457 5.09588 -7.68469 3.80292 +510 2 0.956045 2.28157 7.92852 1.53616 1.67998 2.79736 +511 1 0.311147 15.2759 6.88171 -13.4592 45.4783 4.03261 +512 2 0.500617 15.614 7.76495 4.81164 -9.60864 4.06796 +513 2 0.558697 14.3764 6.88071 13.8097 -37.6199 -4.57419 +514 1 17.0548 6.97395 15.0744 4.20776 -1.94343 -1.58424 +515 2 17.8177 7.57453 14.9855 -5.12063 -2.20736 -0.0554095 +516 2 17.4111 6.17613 15.4934 -0.113823 0.922547 0.618491 +517 1 9.1503 12.5213 8.01319 -14.1189 2.82879 0.278945 +518 2 9.53356 11.9725 7.3299 10.3093 -11.5802 -1.96405 +519 2 8.24075 12.6139 7.71394 -0.988228 2.45183 6.21614 +520 1 1.17609 1.70844 2.83295 3.23913 -2.31621 -1.89882 +521 2 1.09855 2.22978 2.02752 -9.74566 -1.77621 -3.35395 +522 2 1.86202 2.13223 3.34238 5.26299 8.17365 10.1548 +523 1 4.09291 15.1504 9.8922 18.1507 -7.2721 -6.40054 +524 2 4.03036 15.1629 8.92399 -1.00826 2.87435 -0.463193 +525 2 4.99389 14.8146 10.0732 -8.74469 0.915467 -5.31212 +526 1 7.37772 2.25117 14.7222 3.22505 8.21162 1.39777 +527 2 7.09502 1.54536 14.1374 1.57311 -0.181539 -4.41158 +528 2 7.85635 2.90205 14.1691 -14.4419 -9.06063 9.37489 +529 1 18.4006 14.5833 2.15968 -9.78242 8.50711 -1.4388 +530 2 0.62994 14.8842 2.46282 -4.8788 5.17113 -0.292034 +531 2 17.7517 15.3351 2.17575 17.725 -12.6913 0.414249 +532 1 9.99197 2.68277 12.9223 -2.58103 11.7713 -8.17336 +533 2 9.96789 2.1685 12.101 0.346485 -5.49174 3.23624 +534 2 9.29748 3.35451 12.7936 3.47695 -5.23648 4.96996 +535 1 2.96299 8.91941 13.096 19.2939 -0.203164 0.561242 +536 2 3.4486 9.7527 12.8428 -15.067 -18.0348 7.07188 +537 2 3.65865 8.27445 13.3679 -12.9331 14.6867 -6.35999 +538 1 3.26147 8.578 3.77304 6.38222 5.3653 -9.36202 +539 2 3.78874 9.26676 3.32736 -9.65467 -7.00498 -1.39723 +540 2 3.24393 8.8647 4.68594 3.08129 -4.64857 6.90262 +541 1 5.77287 7.24333 8.61048 -1.78661 -5.00814 9.07462 +542 2 5.68022 6.28289 8.53661 4.0016 -1.85755 -4.86386 +543 2 5.00276 7.50215 9.14094 4.61323 4.45406 -2.92895 +544 1 14.8793 1.52937 1.85035 -12.7334 -14.0835 12.9397 +545 2 14.819 2.16152 2.5876 10.8144 6.55959 -13.4181 +546 2 15.5594 1.73936 1.19754 -2.84827 11.2594 2.6977 +547 1 8.5607 15.0611 0.725284 0.46926 -2.1008 2.83341 +548 2 9.29259 14.9147 1.35885 -7.99161 6.01774 -7.32206 +549 2 7.81927 14.5289 1.05772 1.7687 -2.35649 0.826934 +550 1 15.4921 1.3993 7.20702 14.746 2.01238 2.95597 +551 2 14.8484 0.891915 6.72418 -10.4472 -9.96976 -7.88743 +552 2 15.1077 2.27361 7.28199 -8.00989 7.94424 8.07076 +553 1 5.01058 12.9585 18.4386 -15.8567 -4.4202 8.08993 +554 2 5.4193 13.0053 0.667327 2.46468 -0.195888 1.58163 +555 2 5.59523 13.4446 17.8643 8.60291 1.11734 -4.66644 +556 1 15.4019 8.61725 18.0949 -10.0539 -8.80276 13.7753 +557 2 15.8344 9.23888 17.5182 6.53635 7.63687 -15.5634 +558 2 15.1418 9.16559 0.203922 1.58583 0.47418 3.18719 +559 1 12.0525 3.11208 18.2861 7.73999 -14.4321 9.61497 +560 2 12.4007 2.82569 0.495607 -5.57788 10.1171 1.38067 +561 2 12.4066 2.43321 17.7002 -1.56388 4.26076 -9.69121 +562 1 13.1688 12.6857 5.1494 7.31226 -7.20074 3.10637 +563 2 13.4985 11.8462 4.78426 1.65488 6.62932 1.41885 +564 2 13.3525 12.6203 6.1046 -3.90991 6.43934 -4.24709 +565 1 6.08926 7.21668 0.130178 -1.88627 11.2856 16.2629 +566 2 6.12641 8.19603 18.8427 -2.9512 -23.7133 -6.32338 +567 2 5.32645 6.95656 0.679872 3.54107 -2.60359 -10.7249 +568 1 17.6547 15.8703 14.9132 16.2429 2.82715 17.6162 +569 2 16.6953 15.9075 15.0555 4.78919 3.7515 -14.6122 +570 2 17.9345 15.7768 13.9856 -18.469 -1.14955 -2.42085 +571 1 13.1468 0.885591 16.7291 -10.7864 15.024 2.10847 +572 2 14.1008 0.813897 16.7431 10.5998 -4.62802 3.60151 +573 2 12.8375 18.6536 16.4909 -4.88764 -9.34618 2.57866 +574 1 10.8908 14.4992 7.43136 -2.2343 -7.03539 12.0134 +575 2 10.0835 14.2065 7.92308 22.5278 2.1252 -13.3834 +576 2 11.6003 13.8396 7.60224 -11.7269 11.3777 -3.99947 +577 1 17.6181 8.42363 2.12766 -11.9935 -3.6797 -6.77545 +578 2 16.7343 8.37762 2.55285 14.0369 1.72981 -7.6286 +579 2 17.5632 7.81953 1.35766 3.76606 6.32419 13.0143 +580 1 12.3929 7.83138 2.01819 4.71096 17.5308 0.40727 +581 2 12.1717 8.7272 1.7221 -1.13772 -2.1217 4.67191 +582 2 11.9464 7.25327 1.39471 0.282935 -6.68024 -6.10503 +583 1 12.0275 14.6478 10.4009 38.9809 -24.2439 -10.9711 +584 2 12.337 14.044 9.6932 -4.28518 13.1756 12.472 +585 2 11.1105 14.7441 10.2592 -43.0899 4.37787 -4.57767 +586 1 6.8265 6.93238 15.5327 -27.6581 -7.97269 5.64053 +587 2 7.73103 7.08984 15.3178 26.4357 1.09681 -7.32033 +588 2 6.59533 7.63547 16.1384 -2.46814 3.13878 5.80205 +589 1 7.96021 4.51991 13.281 5.98272 36.635 4.98876 +590 2 7.18773 4.72006 12.7149 7.22552 -5.34662 5.9239 +591 2 8.2239 5.40342 13.6709 -8.7699 -31.8396 -11.1478 +592 1 13.3799 12.1942 14.3144 0.413244 -2.26196 2.0512 +593 2 13.2473 11.2333 14.3131 -4.23433 1.2327 0.0241848 +594 2 13.7366 12.3802 13.4362 1.03232 3.06063 -1.77089 +595 1 14.6196 9.43974 7.2819 12.1284 19.1611 12.5008 +596 2 15.4631 9.9012 7.50833 -13.143 -10.3991 -7.78335 +597 2 13.9498 9.89967 7.80701 0.241302 -5.62146 -3.59828 +598 1 12.6688 16.8855 3.24635 -1.47445 -34.5545 -0.541717 +599 2 12.9124 17.3724 4.01195 4.0393 16.1159 25.6755 +600 2 12.6994 17.4999 2.53895 -2.71389 24.0914 -25.4271 +601 1 1.00064 7.12258 17.3474 25.8989 -13.4919 10.9638 +602 2 0.199171 6.81692 17.7654 -17.9333 6.12878 2.90109 +603 2 0.781412 7.72916 16.646 -4.92956 7.36441 -13.84 +604 1 12.947 4.88013 15.7213 -21.2986 7.3754 -0.931645 +605 2 13.7769 4.45629 15.8524 19.8874 -20.9291 -0.114876 +606 2 13.1805 5.80207 15.7513 2.74699 20.2475 2.05037 +607 1 2.36441 3.38825 5.1495 13.4973 -9.76059 -50.575 +608 2 1.87697 2.96062 5.81278 -27.3053 -18.1487 33.2377 +609 2 2.7907 4.09602 5.58982 16.1263 32.9476 11.4061 +610 1 8.23368 10.9868 13.6471 -16.5646 12.9957 -7.98974 +611 2 8.32411 10.9316 14.5895 -0.490848 -4.77914 16.6738 +612 2 9.07298 10.6867 13.3074 11.7511 -8.07538 -9.61613 +613 1 13.0107 1.52025 13.2616 -13.3177 -0.0328213 18.9383 +614 2 13.4383 1.61013 12.4179 13.267 -2.68379 -13.3373 +615 2 12.5185 2.34771 13.3673 3.11016 -7.04189 -1.75869 +616 1 6.59377 13.5764 2.15874 -7.12741 11.9903 -27.1264 +617 2 6.00679 13.9468 2.8128 -10.8754 6.0075 10.3445 +618 2 7.2163 13.0692 2.66145 9.56033 -10.8956 7.78491 +619 1 15.8548 6.42593 12.5881 24.8624 13.3217 16.2273 +620 2 16.4838 6.96617 12.0488 -16.1868 -9.65605 6.77151 +621 2 16.2214 6.49686 13.512 -7.09801 -2.27572 -23.2114 +622 1 16.7956 0.692247 9.54535 7.46915 17.7641 2.49637 +623 2 16.5452 18.5156 9.96298 -0.0131793 -20.516 -0.238231 +624 2 16.2976 0.789947 8.72228 -2.61192 -2.24486 -4.75056 +625 1 6.11318 11.627 8.27064 9.91462 44.2797 -2.20509 +626 2 5.35292 11.2978 8.70378 -29.3613 -6.33495 17.8965 +627 2 6.52877 10.8496 7.97791 23.4734 -34.8725 -13.0112 +628 1 2.81389 8.67751 0.381383 10.1752 -8.74242 -1.84173 +629 2 2.33278 8.32184 18.2713 -4.10181 -2.8979 1.44899 +630 2 2.25425 9.35695 0.757627 -6.74555 6.18422 5.10447 +631 1 10.1136 10.3815 6.5683 -3.97178 -1.84722 1.40214 +632 2 10.6776 9.73953 7.0164 -1.23094 -3.31757 4.86865 +633 2 10.3499 10.3203 5.64027 4.41826 3.29106 -4.73543 +634 1 6.84727 15.7748 6.6764 -14.7135 -11.7826 9.04786 +635 2 7.02398 16.1904 7.53289 5.38031 2.81892 -3.47781 +636 2 6.91879 16.4549 5.99719 9.07918 3.78678 -4.16926 +637 1 6.52182 12.8956 5.7943 0.541827 3.55761 1.99739 +638 2 6.55778 13.7774 6.19915 3.14226 -1.33255 -2.96851 +639 2 6.13082 12.3068 6.44859 -0.859963 5.03094 3.84811 +640 1 16.7567 12.5314 9.76383 -4.64367 0.23861 8.75508 +641 2 16.9908 11.8798 9.10281 -4.06168 -8.34407 -5.30318 +642 2 17.2898 13.2837 9.5332 2.7418 12.1851 0.697411 +643 1 6.23186 2.86269 2.75104 2.97881 8.48666 -1.38882 +644 2 6.52094 3.78037 2.52233 -11.0321 -17.6889 -1.77294 +645 2 5.63962 2.52843 2.04764 8.59188 6.36028 2.68011 +646 1 10.7835 3.03466 3.2504 -5.97107 -1.61798 -4.71292 +647 2 10.2628 3.82076 3.45136 1.61481 0.158577 0.983482 +648 2 10.306 2.59283 2.52669 4.73542 2.88639 2.9637 +ITEM: TIMESTEP +80 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.82629 6.70343 17.8553 -15.1071 8.15122 13.6853 +2 2 7.99416 6.85162 18.349 10.9787 -1.12299 -6.8679 +3 2 8.57507 6.09547 17.1643 3.5075 -8.11573 -6.04158 +4 1 0.137192 8.33532 6.74353 12.0191 -20.4001 -6.39938 +5 2 0.250097 8.10589 5.79669 -2.0008 6.10915 10.6578 +6 2 0.653601 7.63933 7.2162 -12.3825 18.3147 -3.0068 +7 1 8.60149 0.29664 6.93203 12.1667 -9.17994 12.1946 +8 2 9.52501 0.228788 6.64808 -5.75422 4.1152 -0.42095 +9 2 8.21226 0.977159 6.3883 -5.16274 6.48178 -7.47064 +10 1 6.50463 1.68869 11.7262 -16.2706 -7.92373 -2.85274 +11 2 5.9813 2.3145 12.2428 -2.71472 -2.47934 -1.80386 +12 2 5.86927 0.986784 11.4354 16.7384 10.0214 6.53226 +13 1 6.9131 5.55027 2.37535 3.77295 -5.39511 9.11334 +14 2 6.43692 5.84081 3.17655 -0.921031 3.98795 -14.1822 +15 2 6.69543 6.14979 1.6478 1.12895 -1.48609 4.32855 +16 1 16.196 10.2371 16.1388 -31.5516 2.77844 19.9706 +17 2 16.8915 10.3643 15.5412 37.4 6.14414 -23.2997 +18 2 15.8469 11.1288 16.3108 1.55641 -10.2432 -3.37881 +19 1 10.775 14.9631 2.31622 -5.5944 -0.094079 7.63582 +20 2 10.598 14.4521 3.12767 5.78422 3.02899 -5.84463 +21 2 11.1066 15.8146 2.64245 2.43259 -3.51347 -1.1859 +22 1 17.165 8.21001 10.8825 14.1674 -5.9779 -9.25967 +23 2 16.5809 8.83567 11.3092 -8.03296 12.2385 6.15632 +24 2 17.9797 8.71133 10.6858 -5.20793 -0.650283 -1.86008 +25 1 14.6097 15.9558 16.401 14.8916 -7.54315 9.24646 +26 2 13.6847 16.2494 16.4321 3.25844 -2.02272 0.00765398 +27 2 14.8063 15.4932 17.2527 -13.7355 5.39716 -16.4095 +28 1 12.117 13.3155 0.580411 -1.24587 -0.207976 3.78722 +29 2 11.7909 13.4576 18.3369 0.57388 -2.32058 -15.0609 +30 2 11.6242 13.9531 1.10951 4.78037 0.383607 7.31905 +31 1 9.34228 5.488 3.85121 53.6451 1.51077 14.3512 +32 2 8.91013 5.51861 4.6996 -19.4462 -5.34697 10.1126 +33 2 8.70488 5.4763 3.16894 -36.9473 -0.666442 -22.4182 +34 1 1.61615 3.95559 11.5848 -7.57046 15.5603 -11.9076 +35 2 1.66987 4.89506 11.8258 -4.51216 0.523906 3.16779 +36 2 2.10845 3.4705 12.2371 10.5178 -10.3797 12.993 +37 1 2.10284 6.89743 8.15957 -0.837321 -0.675751 7.8246 +38 2 2.47895 7.28827 8.96165 1.07034 3.30836 -6.30935 +39 2 2.071 5.95646 8.37348 -2.86121 -4.48577 -0.939591 +40 1 5.32433 4.44486 7.86972 -1.34052 23.2477 3.45796 +41 2 5.46877 3.5107 7.98026 -0.0649778 -19.4924 -5.7669 +42 2 4.70188 4.60713 7.1427 0.919422 -2.43856 3.29815 +43 1 3.32435 2.88678 17.4197 -1.88929 -9.6261 16.8991 +44 2 4.05816 3.29734 16.977 14.1471 9.33662 -16.3951 +45 2 2.86083 3.59453 17.8818 -3.32176 6.96255 1.50629 +46 1 7.47308 5.51417 6.17701 6.20604 7.73103 -29.885 +47 2 7.95124 6.07722 6.78768 5.01174 3.41934 10.0258 +48 2 7.09189 4.79949 6.66958 -7.20601 -9.71089 14.7057 +49 1 9.80158 6.99902 12.0223 -22.5784 -4.24274 -21.2019 +50 2 10.1069 6.1805 11.5916 -0.00510546 9.67372 7.70676 +51 2 9.03411 7.28611 11.4542 20.6129 -4.31213 14.2424 +52 1 14.1091 3.78361 8.12438 -15.7573 21.5912 -11.6445 +53 2 13.5201 4.50308 7.77049 18.8532 -19.0333 8.38218 +54 2 14.3457 4.04736 9.022 0.199067 1.13361 3.22772 +55 1 4.50215 17.2152 3.88612 2.87802 -1.37968 10.5361 +56 2 5.34021 17.6676 3.86593 13.8498 1.95887 5.68097 +57 2 3.97594 17.6789 3.24294 -11.45 0.485265 -14.6478 +58 1 16.2741 16.534 10.4726 -5.67102 -12.8311 -21.8814 +59 2 15.486 16.5615 11.0293 -1.33881 1.5325 0.205711 +60 2 15.9943 16.0074 9.67798 5.00326 13.1852 19.554 +61 1 1.98121 4.83276 0.125548 -2.90665 -21.863 0.561723 +62 2 2.62989 5.11603 0.769738 5.61812 10.8419 9.00632 +63 2 1.75087 5.59897 18.2498 0.950825 13.4626 -6.91806 +64 1 11.2654 13.2951 16.4195 -4.34554 -2.68737 -1.67212 +65 2 10.7681 12.4683 16.4833 0.87563 -1.05494 5.85319 +66 2 11.8765 13.1105 15.7039 6.19214 3.55339 -6.25188 +67 1 10.1028 10.9035 16.8331 17.2825 8.49241 1.71185 +68 2 10.5205 10.0327 16.7798 -0.767632 10.3686 4.9905 +69 2 9.17724 10.7556 16.7424 -24.4211 -4.37906 -2.41009 +70 1 11.8507 17.4827 13.4696 7.63981 7.03239 -1.88788 +71 2 12.509 16.94 12.9947 -8.02315 8.08552 1.57387 +72 2 12.1795 18.4053 13.408 -3.08283 -9.25718 -0.840972 +73 1 6.44601 9.4433 12.2773 8.37995 -15.986 -34.1351 +74 2 7.00514 9.1357 11.5138 -12.9725 10.8563 23.5312 +75 2 7.03346 9.94503 12.8365 5.04668 8.97956 7.26084 +76 1 16.2979 12.8575 2.71922 -11.7369 16.949 2.19382 +77 2 17.1652 13.221 2.45954 -10.8006 -1.31331 4.0939 +78 2 15.6758 13.6404 2.78783 18.0783 -23.2667 -2.52892 +79 1 0.707968 12.7192 5.87585 -9.46746 -3.17244 -7.34712 +80 2 1.05314 12.7932 4.98248 12.8843 -1.39545 -4.60697 +81 2 18.4375 12.4692 5.68303 -3.12969 3.97578 10.4064 +82 1 5.29671 16.347 18.4316 -9.43352 6.10902 0.949816 +83 2 5.62099 15.5668 17.9615 5.22561 3.70018 3.69326 +84 2 5.92538 16.5961 0.477291 0.486221 -4.47534 -1.04063 +85 1 0.707184 7.70367 4.119 -51.5024 -35.8612 26.1825 +86 2 0.14378 7.97362 3.40377 -12.5647 4.97441 -12.5535 +87 2 1.50957 8.08535 3.91273 65.7491 26.1316 -14.6887 +88 1 3.20348 9.03456 6.50534 -36.9666 27.611 -24.7826 +89 2 3.63112 8.56754 7.174 27.0077 -25.2244 35.3222 +90 2 2.25579 8.96355 6.72902 9.17057 2.1904 -6.46933 +91 1 7.27937 10.3761 16.2413 -0.230914 -4.48303 6.76598 +92 2 6.52755 10.9587 16.1419 -2.56448 5.11938 -3.06937 +93 2 7.11485 9.96393 17.0986 -0.495486 0.80288 1.59662 +94 1 11.0332 0.910989 5.0177 -6.88619 -3.17881 -8.23488 +95 2 10.972 1.75479 4.54866 7.92386 3.49104 7.17877 +96 2 10.6826 0.325395 4.32946 5.79259 -4.26916 6.55693 +97 1 4.2654 2.89302 13.1773 0.694211 20.6748 -2.64105 +98 2 4.39238 3.45448 13.9576 1.0821 -9.7456 0.782255 +99 2 4.16489 1.98946 13.4871 -0.702651 -10.6992 3.24412 +100 1 8.43419 10.272 1.79599 3.30535 -21.7188 -14.6566 +101 2 8.19585 10.8779 2.48837 0.0509316 11.2873 19.613 +102 2 8.53541 9.39344 2.20281 2.46081 9.96427 2.84146 +103 1 10.2486 1.68186 15.4597 -14.9494 5.38019 -3.47887 +104 2 11.0964 1.37036 15.7536 17.388 -0.916576 -1.92962 +105 2 10.2694 1.89097 14.5087 2.57313 -1.10767 6.05091 +106 1 2.6143 12.7739 7.92246 0.947228 -0.997667 -1.9326 +107 2 3.16975 13.4683 7.54148 -0.729705 2.73148 -0.490338 +108 2 1.96608 12.5591 7.23618 1.36975 0.244975 0.56737 +109 1 3.86268 11.7535 5.00307 -14.4028 -3.16999 8.33757 +110 2 3.70976 11.1475 5.74815 1.12966 3.67823 -8.44516 +111 2 3.06255 11.7297 4.44022 7.7842 4.67892 9.37694 +112 1 6.76061 14.5167 16.9537 -0.888094 -7.58336 -2.84579 +113 2 7.48488 15.1306 17.0914 4.64858 -1.1877 -1.93173 +114 2 6.56705 14.5225 16.0035 -2.02875 6.77169 3.29706 +115 1 14.2034 14.5245 3.20058 -0.0398844 -12.3077 5.38397 +116 2 13.8793 15.4221 3.34301 -5.62621 -2.27359 -1.58508 +117 2 13.7959 13.9448 3.87781 2.42748 11.415 -6.18352 +118 1 8.70505 18.0887 16.0942 -64.5065 -8.09898 -3.91687 +119 2 9.21396 17.4083 16.5058 25.0639 -11.349 2.42178 +120 2 9.16407 0.206988 15.7928 30.835 22.2192 -2.21878 +121 1 4.63692 1.68417 4.88655 37.1566 -9.63698 -3.58798 +122 2 3.87701 2.22405 4.82391 -30.2785 19.7734 3.84799 +123 2 5.28246 2.1077 4.29595 -5.87377 -5.36693 3.35208 +124 1 15.0131 12.6297 16.4887 -20.293 3.22713 36.7225 +125 2 14.5244 12.6173 17.3484 21.3151 5.53737 -15.2497 +126 2 14.2857 12.586 15.869 -0.208138 -0.973548 -24.0506 +127 1 15.729 18.4304 16.8576 -8.95075 23.4819 -17.3869 +128 2 16.2245 18.5231 17.6612 15.7889 -2.20706 14.0604 +129 2 15.4698 17.5226 16.786 -7.06215 -23.0828 1.02158 +130 1 1.394 1.31209 16.6703 -16.8241 -3.16738 2.04331 +131 2 2.15084 1.87826 16.8449 0.715689 -4.34048 -2.49358 +132 2 0.715561 1.66179 17.2756 6.00571 -5.18273 -5.07353 +133 1 18.2252 4.3402 15.9772 -8.55569 -2.73 -13.6324 +134 2 17.823 3.76125 15.3072 5.10239 5.23383 8.49054 +135 2 0.492866 4.4785 15.7127 2.39871 -0.864238 1.29175 +136 1 12.1265 17.032 16.1255 -25.5416 -7.58495 15.967 +137 2 11.3669 16.5924 16.5691 16.6277 5.86514 -1.80192 +138 2 11.8242 17.0598 15.2127 8.00105 4.8532 -10.0676 +139 1 16.1291 2.68344 18.211 0.375456 -13.3929 15.5569 +140 2 15.6138 3.3874 18.6109 -0.098248 15.4546 -4.83257 +141 2 15.8549 2.61026 17.3068 -10.5356 1.78345 -20.9571 +142 1 6.60182 13.7939 10.068 9.2492 3.65708 4.18485 +143 2 6.57275 13.4224 10.9661 -3.78941 -3.14938 -5.19226 +144 2 6.71396 13.0652 9.44214 -7.17216 -3.95227 2.85982 +145 1 10.1302 18.5571 2.70452 28.7428 2.61674 -1.08827 +146 2 10.6588 0.134354 1.90491 -8.77267 0.774664 16.1596 +147 2 9.28539 18.2699 2.40893 -22.5926 -9.32297 -10.0302 +148 1 3.0625 17.7033 6.15366 -32.6923 -3.28618 14.6113 +149 2 2.13754 17.6931 5.7562 38.9757 -0.864197 5.33283 +150 2 3.7049 17.7316 5.44436 -0.964713 0.371031 -13.1926 +151 1 12.6087 16.7853 7.93012 21.3772 -3.32102 -23.3093 +152 2 11.8409 16.2517 7.71322 -11.0279 -6.8961 6.738 +153 2 12.4183 17.3739 8.65053 -14.1479 13.0972 16.1976 +154 1 14.9031 15.2939 8.2802 -30.4011 23.5185 11.3145 +155 2 14.1656 15.9721 8.20757 23.4522 -23.8051 0.0341398 +156 2 15.3634 15.3182 7.4362 3.9964 4.48103 -1.46252 +157 1 17.8706 18.2596 0.245663 2.0948 -17.0514 -11.0411 +158 2 18.6148 17.6985 18.5349 -15.5847 20.6608 16.06 +159 2 18.229 0.448391 0.574358 6.37924 -1.254 -0.87753 +160 1 0.806491 10.487 1.42673 -7.2326 -9.98023 10.4462 +161 2 -0.00161399 9.98055 1.66044 10.6613 4.25192 -4.69396 +162 2 0.557346 11.1929 0.820979 -4.09494 2.43397 -4.83249 +163 1 1.83456 12.2686 3.29043 -8.34448 2.57963 -8.45001 +164 2 1.36787 11.5875 2.7525 13.033 10.6511 2.37549 +165 2 2.15971 12.967 2.6794 -8.27007 -10.3927 7.15994 +166 1 0.688934 17.2807 4.96532 -1.28513 13.5074 -14.6034 +167 2 -0.0176841 17.9487 5.11769 8.40666 -17.1979 3.35047 +168 2 0.596617 16.4414 5.43231 -12.6974 4.79178 9.39957 +169 1 1.09014 0.907525 9.3383 6.29421 1.3921 30.3575 +170 2 1.25758 0.656293 10.2983 -10.9635 5.07818 -25.2558 +171 2 0.281108 0.475301 9.05696 -4.67463 -4.0945 4.23309 +172 1 16.7684 2.39691 13.3495 9.61769 42.5491 2.72371 +173 2 16.904 2.78957 12.4595 -0.731435 -13.0756 10.2936 +174 2 16.527 1.48948 13.2642 -5.98641 -27.7824 -4.48506 +175 1 2.71373 15.9459 12.053 -3.75115 0.267025 20.4445 +176 2 2.98439 15.5717 12.9162 -2.14108 4.62523 -16.3505 +177 2 3.30112 15.6057 11.3695 4.80572 -2.00813 -1.58569 +178 1 16.3912 15.5658 6.1364 -18.5193 -23.7813 -1.39285 +179 2 17.3153 15.4712 6.31079 23.2449 0.130836 8.54259 +180 2 16.3263 16.278 5.5153 -3.20698 17.7917 -15.4301 +181 1 5.73039 5.21537 11.7967 -2.24013 5.33831 8.85226 +182 2 5.58704 6.03693 12.3192 -1.36073 -15.5687 -10.3459 +183 2 5.0707 4.59019 12.1393 4.45693 0.898588 -6.68224 +184 1 15.134 4.90094 0.781902 20.2218 -12.3751 4.08616 +185 2 14.9115 4.68422 1.69179 -1.28767 -2.72314 10.4735 +186 2 14.3889 5.35469 0.437757 -23.5901 14.4279 -10.7703 +187 1 16.3592 16.4594 1.89384 25.1746 19.6936 -18.9686 +188 2 16.2469 16.8 2.79117 -6.86302 3.67352 0.481682 +189 2 16.829 17.1783 1.36994 -16.7874 -21.2348 17.437 +190 1 0.175681 4.85349 3.94905 -38.6563 1.2533 -4.07114 +191 2 0.373462 5.78529 3.89581 11.5619 13.3417 2.94095 +192 2 0.969717 4.36237 4.02266 30.2668 -11.0427 7.4994 +193 1 2.99204 15.0813 15.1763 -0.305205 14.4793 -34.7595 +194 2 2.88713 14.6595 16.0135 -9.94348 -6.29569 26.5741 +195 2 2.4481 15.8945 15.1967 6.07768 -3.34342 6.9782 +196 1 1.12287 14.6661 9.5226 42.1359 23.511 16.8308 +197 2 2.04871 14.8527 9.88052 -40.3465 -4.39318 -17.9218 +198 2 1.08708 13.7187 9.50981 -4.88478 -15.9854 1.2011 +199 1 13.5299 16.5144 11.5405 11.2356 18.9117 4.33104 +200 2 13.1159 17.2557 11.0661 2.81218 -0.6798 2.92705 +201 2 13.1037 15.7572 11.1579 -10.8238 -16.1215 -4.14744 +202 1 4.70977 1.52963 0.718559 3.58248 -24.4192 11.8527 +203 2 4.08939 1.89433 0.0933404 -5.33693 14.3563 -9.66083 +204 2 4.20955 0.796838 1.1277 3.32575 8.01941 1.68952 +205 1 1.50238 18.6141 11.9042 -1.38031 13.5472 16.8753 +206 2 1.45658 0.425239 12.7856 -0.241625 -6.75063 -24.7438 +207 2 2.14944 17.9089 11.9973 -1.06457 -6.06855 3.15913 +208 1 11.4462 10.1354 4.10554 -27.8103 0.519562 13.0103 +209 2 11.5399 10.6236 3.29381 1.04561 4.25273 -17.1067 +210 2 12.3232 9.96387 4.39943 30.3669 -4.33072 3.08727 +211 1 8.16113 12.1728 3.80004 4.97071 -3.14572 14.2587 +212 2 8.9952 12.5305 4.11747 11.4774 1.91239 -11.4095 +213 2 7.64202 12.24 4.61417 -11.8418 -2.63078 -6.07404 +214 1 14.5844 4.03291 3.36716 -4.11232 -3.55002 -24.3582 +215 2 15.2517 4.33672 3.97304 10.7234 0.0718586 14.5399 +216 2 13.7453 4.32617 3.71649 -8.9869 4.72015 4.68372 +217 1 5.72064 1.64489 7.5839 32.9059 28.6425 0.0988457 +218 2 5.06921 1.12259 7.98588 -34.2591 -28.2453 24.4599 +219 2 5.39575 1.74393 6.6993 -3.28926 -2.3453 -25.2911 +220 1 17.8815 1.07824 4.83341 -4.77439 -8.44394 -0.469265 +221 2 18.4195 1.29399 4.06103 3.32925 4.9906 2.38586 +222 2 18.1973 1.60106 5.58304 1.56226 2.04575 -0.708791 +223 1 6.854 9.3046 4.53528 10.3956 -9.62802 3.27507 +224 2 6.69426 9.36632 5.492 2.76918 3.19153 -6.51095 +225 2 7.80605 9.0738 4.45229 -13.5827 1.70924 -0.808399 +226 1 2.59539 14.8276 2.04954 -21.4179 -5.20739 -34.911 +227 2 3.34516 14.7063 2.60932 22.2061 -1.352 15.1427 +228 2 2.90646 14.7931 1.11821 -3.29515 2.22824 22.2692 +229 1 17.3057 12.9587 13.1574 -14.3584 11.8265 -1.68619 +230 2 16.4238 13.3017 13.4505 21.6076 -1.54195 -11.2195 +231 2 17.8123 13.7306 12.814 -13.7958 -9.76612 7.37248 +232 1 14.8715 10.5568 1.52593 -13.8049 33.9422 19.399 +233 2 15.3968 11.3309 1.89043 -12.48 -24.7346 -11.1652 +234 2 13.9264 10.776 1.72699 26.333 -7.21409 -8.066 +235 1 5.65075 6.69227 4.53589 -1.16643 0.470211 -4.08107 +236 2 5.90168 7.60385 4.33311 1.92457 3.57872 5.04239 +237 2 6.31691 6.35225 5.15026 1.24698 1.28263 2.78678 +238 1 8.00933 8.29789 10.2803 -8.03608 2.46456 2.45807 +239 2 8.54459 8.86115 9.67988 -10.051 -7.82575 5.32423 +240 2 7.18397 7.98917 9.84875 17.8376 0.213066 -8.74409 +241 1 13.4452 18.4811 5.71348 30.3006 1.0471 -14.1486 +242 2 12.642 0.299737 5.48582 -19.0854 8.92614 -0.688815 +243 2 13.1967 17.7426 6.25238 -10.7462 -10.7439 19.4962 +244 1 -0.0119027 2.59488 0.354931 35.8038 -39.8932 13.3955 +245 2 17.7273 2.51611 0.10594 -24.5443 11.4005 -8.19311 +246 2 0.27212 3.48779 0.285479 3.99253 30.2779 -6.4317 +247 1 12.849 10.869 9.75158 -6.21929 20.5855 -7.88953 +248 2 11.8713 10.9784 9.78619 15.6811 -13.8069 -0.457669 +249 2 13.0615 9.92753 9.83861 -13.7986 2.36182 2.76964 +250 1 0.623186 12.214 11.083 4.78072 12.4497 9.66308 +251 2 18.3291 12.2937 11.2784 -7.07035 -2.86266 -6.1852 +252 2 1.03568 12.566 11.8864 5.16139 -3.44089 -5.05626 +253 1 5.24317 7.35288 13.329 16.5645 10.6427 9.86574 +254 2 5.81232 8.06371 12.9598 -16.2044 -6.02954 3.80806 +255 2 5.63373 7.21351 14.2126 -3.74153 -4.80134 -10.81 +256 1 1.17457 6.8033 11.9036 -23.8679 10.4664 -9.71638 +257 2 0.289623 7.06715 11.5324 26.398 -8.64759 11.7652 +258 2 1.56564 7.61974 12.2537 0.753648 -2.9175 -1.70229 +259 1 15.4919 9.76734 12.3795 0.0614124 -7.36309 3.05776 +260 2 15.0846 10.6319 12.2391 7.36463 -2.83561 -3.47144 +261 2 15.8873 9.82027 13.2467 -0.105969 -0.524429 6.2821 +262 1 16.5022 12.5635 5.51418 5.92626 -4.93161 -13.1981 +263 2 16.3002 13.4761 5.69188 -2.75562 16.3616 9.80459 +264 2 16.3759 12.5305 4.55079 1.66896 -8.7704 1.12914 +265 1 6.31756 9.85145 0.122373 -12.0354 8.37982 6.54531 +266 2 5.4699 10.2439 0.423151 12.3884 -4.45977 -3.2374 +267 2 6.98984 10.1338 0.758446 2.49067 2.04662 0.271789 +268 1 12.1918 6.08954 4.01066 -16.388 -25.9861 2.6766 +269 2 12.1912 6.72626 3.29268 0.559249 7.6643 3.09763 +270 2 11.3251 5.63233 3.94387 14.2823 13.1494 2.08097 +271 1 0.332379 12.8663 0.0441745 0.0508304 2.00456 8.93046 +272 2 18.9019 13.5185 0.756349 -7.27218 -2.99587 0.981784 +273 2 18.3327 13.1573 18.0278 2.80865 -1.79272 -4.8195 +274 1 3.54313 0.0443203 8.66238 11.9606 -6.13667 -3.48184 +275 2 3.32458 18.1774 7.87344 8.237 1.02812 -5.83338 +276 2 2.68777 0.391851 8.89446 -8.31408 9.03305 4.42594 +277 1 7.44404 17.5122 4.49167 0.119683 3.6114 3.91179 +278 2 7.85567 18.3869 4.65486 -14.0238 -13.6963 -7.23825 +279 2 7.39901 17.3877 3.53399 5.58618 2.96743 1.37553 +280 1 9.26713 17.153 12.2094 -20.2295 17.8608 7.81194 +281 2 9.28392 16.3133 11.7674 1.3049 -15.888 -12.5165 +282 2 10.076 17.208 12.7094 15.0452 0.291548 7.10451 +283 1 13.4068 13.0832 7.92217 -6.10698 -2.73533 15.5952 +284 2 13.4694 12.4257 8.66119 -0.459118 13.24 -15.7611 +285 2 13.8946 13.8972 8.17425 4.86633 -17.7849 -1.17812 +286 1 14.7977 2.95386 15.4326 21.7471 11.1646 11.1554 +287 2 14.1505 2.32893 15.1446 -13.9872 -17.9607 -8.38755 +288 2 15.4352 3.02911 14.7173 3.23846 -4.77681 -7.04868 +289 1 9.91022 15.6467 16.9338 -7.88269 11.4297 -3.43074 +290 2 10.0979 14.7902 16.532 6.40878 -6.10819 3.84543 +291 2 9.43747 15.4751 17.7557 1.6004 -7.26983 6.6271 +292 1 11.2148 8.51865 16.6243 -9.14606 -19.2231 -14.9185 +293 2 10.4285 8.06123 16.2547 13.8022 0.848227 5.21642 +294 2 11.6642 7.88268 17.1928 -1.33785 -0.880144 3.29074 +295 1 3.96477 18.2022 16.8388 0.151724 27.8243 14.0652 +296 2 4.47646 17.6367 17.4198 3.54357 -14.0579 0.0762873 +297 2 4.08749 0.446059 17.2373 -6.51294 -16.617 -15.0442 +298 1 2.23636 4.23466 8.90617 11.6474 4.96614 0.176633 +299 2 3.18727 4.06881 8.84702 -5.0902 0.586039 -2.82984 +300 2 2.03755 4.18072 9.84669 -2.61694 -5.47133 1.10155 +301 1 9.89683 10.3797 9.78633 12.6385 -21.4053 -24.2531 +302 2 9.49137 11.1552 9.42946 -10.1833 20.5571 -3.63947 +303 2 9.86232 10.3926 10.7266 0.554165 3.61624 28.8421 +304 1 9.72109 0.91625 10.832 13.6195 9.02414 1.59857 +305 2 9.21789 0.206273 11.2536 -3.38139 -4.49977 -6.76529 +306 2 9.17946 1.37162 10.1615 -3.40595 -8.11879 6.74876 +307 1 9.15707 15.1255 10.1914 20.6551 -3.22149 9.33909 +308 2 9.01609 15.916 9.68312 -8.41387 13.877 -8.61246 +309 2 8.34011 14.6408 10.1195 -14.233 -7.19689 -0.719266 +310 1 0.808146 9.70808 10.2086 23.84 -38.9856 -20.0319 +311 2 0.930598 10.6496 10.3444 5.65872 6.03362 4.8682 +312 2 1.64643 9.29884 9.83207 -32.5144 23.6532 16.8406 +313 1 17.0698 4.80337 8.05752 27.8638 -35.1931 -3.66362 +314 2 16.2966 5.30586 8.21629 -27.2809 18.9512 9.97555 +315 2 16.9993 3.9693 8.55928 -0.62818 15.8913 -5.61459 +316 1 14.8223 14.6574 0.153467 -11.4546 -14.4551 -9.90243 +317 2 15.436 15.0274 0.766448 14.8773 15.1477 17.5942 +318 2 14.121 14.2916 0.705806 -3.92817 0.026116 -2.07816 +319 1 3.85634 11.0156 9.57857 3.75671 2.20251 0.903354 +320 2 3.89754 11.3203 10.4983 -5.37308 2.01291 2.42961 +321 2 3.35837 11.6719 9.06911 -6.8083 1.73507 0.204751 +322 1 11.3728 10.7464 1.42992 33.2497 -4.81825 9.44885 +323 2 11.5281 11.6383 1.10055 0.915848 5.55374 -4.33141 +324 2 10.4426 10.6155 1.47257 -31.1398 -0.627116 -5.41705 +325 1 13.1828 7.20447 12.6676 -0.0478479 -14.2604 -0.4669 +326 2 14.1298 6.99811 12.5505 -7.76827 -0.67018 4.43892 +327 2 12.735 6.32848 12.7534 7.45412 15.7346 -2.47341 +328 1 9.63194 1.91441 0.890304 3.16134 4.31897 -8.70512 +329 2 8.77158 1.63222 0.526893 10.8452 7.48256 0.350857 +330 2 10.2032 2.19638 0.151243 -8.90992 -2.48069 6.74103 +331 1 10.6318 13.4626 4.55882 -11.5056 -1.99047 12.5083 +332 2 11.4876 13.0509 4.71851 7.47615 -1.29416 -2.63952 +333 2 10.4232 13.8662 5.41293 0.691023 4.41994 -1.81408 +334 1 14.5517 1.66181 10.9802 -11.5576 12.9 9.45395 +335 2 15.3776 1.3055 10.6442 8.04202 2.4344 -3.19562 +336 2 14.6907 2.6148 11.169 4.38713 -8.31284 -15.1855 +337 1 14.4901 12.0498 11.5809 -31.454 -4.77499 25.6083 +338 2 15.091 12.4736 11.0015 28.7023 12.1919 -21.8177 +339 2 13.8321 11.6274 11.0162 -1.74489 3.16984 -4.97875 +340 1 8.17369 5.13537 9.87952 -12.8505 7.96449 12.3464 +341 2 7.30162 5.126 10.3345 14.626 0.500686 -8.94194 +342 2 8.32701 4.24033 9.57061 -3.03583 -8.79147 -1.32617 +343 1 1.61182 16.9829 18.4557 19.3906 15.8485 -25.2691 +344 2 2.09739 17.4464 17.7224 -9.17701 -12.9822 18.3353 +345 2 1.80792 16.0477 18.3234 -0.14796 -4.92565 -1.79656 +346 1 1.43858 17.3769 15.3174 -8.9259 8.94647 7.52005 +347 2 1.45812 18.1702 15.9147 -6.93156 -15.9408 -17.1792 +348 2 0.507347 17.0882 15.1685 14.4449 8.30676 8.33907 +349 1 3.5257 5.78471 6.06613 -3.39677 -13.3058 1.89016 +350 2 2.9753 6.46227 6.46115 -3.38454 1.41808 7.55669 +351 2 4.15739 6.26663 5.53865 9.2569 4.30143 -12.1591 +352 1 12.629 9.51298 14.2604 -9.77978 19.3775 3.35531 +353 2 12.9437 8.76225 13.7938 15.2815 -22.6591 -22.819 +354 2 12.3447 9.10922 15.0729 -6.56341 1.36458 18.6396 +355 1 4.0928 15.2431 7.0497 -2.25109 -22.7738 13.7055 +356 2 3.66448 16.0653 6.81785 -2.80743 13.3283 -7.68 +357 2 5.04695 15.3859 7.01583 3.36741 6.66555 -6.63338 +358 1 0.780201 8.79903 15.0924 -4.1065 -28.223 6.26572 +359 2 0.548696 9.72105 15.1288 -1.34907 18.7642 -4.10325 +360 2 1.5752 8.72345 14.5481 -0.207921 7.22304 -3.82448 +361 1 12.9286 8.29499 10.1476 33.3114 -28.911 32.5654 +362 2 13.7554 7.80683 9.90421 -18.1809 10.2081 -7.43875 +363 2 12.9042 8.10572 11.1188 -9.83308 4.93442 -19.3471 +364 1 15.2998 7.93844 3.50826 -21.0939 -7.00262 -11.8412 +365 2 14.4558 7.58878 3.24395 -11.6977 10.4201 -28.099 +366 2 15.3831 7.3862 4.26257 30.2163 -1.92794 33.2483 +367 1 17.18 6.71526 18.6425 -0.133844 12.8911 -12.7702 +368 2 16.7451 5.93694 0.322596 -6.25651 -15.7248 7.28694 +369 2 16.4413 7.25778 18.3094 9.30548 1.37884 5.01187 +370 1 8.9084 6.99396 7.88573 -0.881002 2.32267 0.0260346 +371 2 9.83584 7.2627 7.79742 -0.0847644 -0.13812 3.11438 +372 2 8.83558 6.46246 8.69404 -0.0294368 0.694249 -1.22754 +373 1 12.437 0.501834 1.22358 -0.716997 -8.58934 -9.29719 +374 2 13.1312 1.05983 1.5788 8.89791 0.478791 5.50433 +375 2 12.732 0.307907 0.326573 -3.73597 1.67796 1.81541 +376 1 5.69458 15.0516 14.5143 3.69591 -14.2553 -4.53333 +377 2 4.76954 15.0969 14.776 -8.31751 1.66253 0.63197 +378 2 5.95328 15.9515 14.3109 5.80865 11.3045 -3.56535 +379 1 3.78081 6.42509 1.75203 4.2348 -8.30075 -4.29513 +380 2 3.33672 7.18396 1.37288 -3.60544 13.0853 -6.67388 +381 2 3.84967 6.63422 2.68491 0.545892 0.795555 6.86444 +382 1 3.88792 11.3989 12.3546 13.0971 -5.24635 -8.64578 +383 2 4.74838 11.8202 12.5261 -6.66532 -1.91753 0.168546 +384 2 3.23677 11.927 12.8169 -5.64663 9.70313 4.55872 +385 1 5.30252 3.85246 15.7701 3.45242 11.6571 4.53522 +386 2 6.06202 3.27771 15.61 2.30678 -4.65184 -5.35711 +387 2 5.68598 4.72788 15.9368 -2.89319 -4.23448 -3.12102 +388 1 14.1378 10.1309 4.62741 -6.40911 2.93718 -21.1253 +389 2 14.285 9.82325 5.50803 7.98673 -9.05047 24.7099 +390 2 14.6717 9.53242 4.07811 -2.84302 6.29722 1.17771 +391 1 7.65634 17.3346 9.10408 10.3132 -24.7491 -1.74792 +392 2 7.07794 17.6856 9.78277 -9.16436 8.21537 0.604828 +393 2 7.96278 18.0151 8.50473 -0.553145 15.1908 -4.94918 +394 1 4.52232 14.5173 3.95827 12.1345 -25.6108 -47.7046 +395 2 4.42958 15.3956 4.25649 -1.76895 36.8878 18.7873 +396 2 4.4098 13.9051 4.66351 -3.8607 -15.3504 25.5968 +397 1 14.1258 7.45828 15.8364 -6.23365 -6.73609 3.75314 +398 2 14.9302 7.39167 15.3277 7.57838 -0.290505 -5.08612 +399 2 14.4287 7.78058 16.69 -2.09073 5.34234 4.78248 +400 1 2.95098 18.3751 1.91859 -29.5535 -1.78839 -16.8987 +401 2 2.45071 17.8858 1.20736 17.1758 4.42604 21.0133 +402 2 2.2449 0.246547 2.36374 11.8246 -5.6794 -7.15496 +403 1 7.99154 1.5773 4.49846 30.6245 -5.45524 3.73918 +404 2 7.42382 1.97686 3.83614 -1.09908 5.00667 -8.45405 +405 2 8.90683 1.55308 4.13454 -22.7919 6.21994 3.05753 +406 1 2.44336 14.1732 17.7263 2.89693 8.8065 2.99283 +407 2 1.80182 13.5359 18.0713 -0.462046 0.279758 -5.24045 +408 2 3.30188 13.814 17.96 10.6791 -8.66055 4.12847 +409 1 0.94217 1.90899 13.8934 13.5408 -1.52741 -1.05885 +410 2 1.19747 1.57322 14.7589 -4.95142 3.16298 5.50662 +411 2 18.6373 2.03702 13.8998 -8.7871 -0.483879 -2.02084 +412 1 4.30938 0.151078 13.8855 7.43827 7.09651 -9.2822 +413 2 5.23906 18.5299 13.9426 -3.76642 -3.92995 -1.86801 +414 2 3.88869 18.4591 14.673 -3.49259 -4.03929 12.0029 +415 1 7.32054 0.93366 18.4163 -33.3446 -10.4004 5.92831 +416 2 7.32153 0.654144 17.4916 5.03052 -1.00997 0.0977128 +417 2 6.36163 0.937686 18.6972 26.0729 9.45288 -6.86634 +418 1 15.8933 18.4156 13.9169 -22.9956 8.12347 -47.8741 +419 2 14.9583 18.5802 13.6337 24.0447 -6.26997 16.1472 +420 2 15.9487 18.2637 14.8423 -3.56821 2.97357 29.888 +421 1 10.2651 4.57121 16.2688 1.93413 -35.0494 -13.7078 +422 2 11.2092 4.46181 16.4883 -7.31309 8.12251 -3.69007 +423 2 10.0229 3.6678 15.9192 2.49448 27.3645 14.4368 +424 1 15.9059 17.707 4.46041 -10.2591 -26.7612 -3.24664 +425 2 16.489 18.4443 4.44561 19.3223 26.1038 4.21423 +426 2 15.1093 18.0276 4.88994 -9.23113 3.77657 -1.20249 +427 1 6.91304 17.5561 13.9404 -32.5423 1.81832 8.8205 +428 2 7.45718 17.7359 14.6891 13.6263 3.56972 27.349 +429 2 7.55119 17.4736 13.2627 22.9256 -5.60471 -32.7019 +430 1 13.1887 6.46821 6.52506 2.14134 -6.99498 -16.9539 +431 2 14.1468 6.55272 6.36688 -10.1834 4.86047 2.66897 +432 2 12.7776 6.33144 5.63446 11.1073 4.86992 20.3892 +433 1 7.86929 2.3014 9.43186 -7.43999 -0.581733 -7.42672 +434 2 7.28758 2.26368 10.206 1.54253 -4.13193 1.23421 +435 2 7.37428 1.85692 8.71867 3.17855 7.90221 2.8646 +436 1 15.2039 14.7441 13.779 -1.62406 2.57688 -1.70285 +437 2 14.9354 14.9492 14.6806 -4.8726 3.09257 3.44485 +438 2 14.7582 15.3762 13.1995 0.661267 -3.02741 1.58802 +439 1 9.4149 8.38535 3.859 -25.1665 -10.991 -5.57318 +440 2 10.2049 8.88585 3.99067 20.2759 12.8236 2.22258 +441 2 9.67249 7.46496 3.96553 -1.56288 -2.67339 -2.00262 +442 1 17.7026 13.5834 16.4242 -1.80346 -11.0476 6.4727 +443 2 16.7549 13.3713 16.3986 -0.662501 7.25922 -2.44544 +444 2 17.8485 14.4294 15.9813 -4.13054 1.45271 -4.35383 +445 1 4.91191 10.5224 2.88074 35.1139 -21.7488 -13.7776 +446 2 5.74832 10.1175 3.20879 -18.1595 7.39309 -6.65206 +447 2 4.64711 11.0636 3.60968 -4.98951 12.9254 11.8317 +448 1 3.70989 8.40692 9.9178 -3.43098 -13.3807 16.77 +449 2 3.72102 9.34916 9.72654 3.49477 5.64054 -2.09668 +450 2 3.74613 8.34545 10.8924 -2.49133 1.09455 -12.0955 +451 1 15.9811 6.93645 5.90716 -9.64967 -5.56515 0.983492 +452 2 16.7246 7.40088 6.29715 7.31355 3.31596 3.21676 +453 2 16.2311 6.00551 5.84179 2.78737 3.87161 -3.53071 +454 1 15.2416 7.2288 8.97537 -25.1477 -13.3308 -14.4253 +455 2 15.9965 7.60799 9.37505 30.1105 10.4166 22.3283 +456 2 15.0439 7.80906 8.23828 -3.19363 1.15625 -6.55237 +457 1 6.20437 12.8345 12.7354 -14.1465 10.1654 -16.7884 +458 2 6.94522 12.3758 13.1101 18.4885 -10.5564 10.7987 +459 2 6.04629 13.6348 13.2503 2.66058 2.52169 8.79246 +460 1 12.1262 4.55048 13.1243 17.0811 13.049 12.1055 +461 2 12.3395 4.65477 14.0809 -9.37635 -6.07885 -14.152 +462 2 11.329 4.03313 13.0256 -8.31182 -5.5816 3.57791 +463 1 11.4354 8.07801 7.94226 -0.810806 3.70784 -8.7596 +464 2 12.2037 7.66847 7.47953 -11.1819 -0.00285319 12.9065 +465 2 11.6202 8.13058 8.89801 9.03316 -1.52538 -12.7532 +466 1 16.9943 10.8342 7.6109 -5.03955 -8.49642 17.9987 +467 2 17.7716 10.3123 7.42961 10.8043 -13.0503 -0.479497 +468 2 16.9113 11.4133 6.86596 -8.14606 13.8231 -19.3584 +469 1 5.21042 18.0585 10.7699 15.6232 7.92267 2.97831 +470 2 4.74775 17.5474 11.4283 -5.6196 -5.04348 5.46467 +471 2 4.57391 18.2408 10.077 -8.01525 -1.2934 -10.8517 +472 1 7.60043 17.4332 1.64042 6.79415 6.05281 -21.827 +473 2 7.93761 16.6332 1.20425 2.91062 0.230192 8.27204 +474 2 7.75711 18.1408 0.980897 -9.32049 -5.6032 10.0359 +475 1 1.93897 12.9382 13.63 3.13689 -3.11692 -16.6768 +476 2 1.43678 12.3217 14.1546 -10.1951 -7.38374 9.42459 +477 2 2.04891 13.7234 14.1672 6.66588 6.79896 5.37665 +478 1 9.3938 6.77683 14.8244 15.3217 -3.43003 -1.39025 +479 2 9.8639 6.00007 15.2423 -8.39432 15.0581 -15.9266 +480 2 9.75443 6.97816 13.9251 -4.83499 -14.7492 16.6004 +481 1 15.2802 4.37234 10.7612 17.1837 -0.598437 7.1821 +482 2 16.2442 4.23454 10.6079 -20.4209 -0.451849 5.19081 +483 2 15.2528 4.98337 11.5249 -0.66536 -5.42981 -12.7574 +484 1 11.4105 6.21551 0.0734026 -8.7314 7.93342 -2.27424 +485 2 11.3895 5.26963 0.0141504 12.2817 -18.3718 -0.889513 +486 2 10.499 6.41528 18.4856 -6.56297 9.87049 -0.998012 +487 1 18.513 11.4235 14.9225 12.9282 -22.681 3.72438 +488 2 17.9895 11.7369 14.1972 -5.90482 9.25399 -19.4183 +489 2 18.3571 12.0937 15.574 -0.537982 14.5307 17.0247 +490 1 7.08328 9.28085 7.30918 -19.7197 4.18214 5.56511 +491 2 6.73297 8.51044 7.78417 1.76821 -0.286333 -7.5509 +492 2 8.01676 9.1548 7.24802 24.3996 -5.081 -1.83944 +493 1 18.3255 15.3437 12.2137 -3.8694 0.735905 0.400418 +494 2 0.599616 15.5 11.9645 6.26195 2.32841 -0.363056 +495 2 17.7995 15.7522 11.5099 -2.40985 0.96637 0.371307 +496 1 16.511 4.37404 5.22763 -21.2214 -5.51878 25.3236 +497 2 16.4647 3.99489 6.12381 2.74309 1.28503 -9.80457 +498 2 17.4303 4.54035 5.0616 22.4703 -0.915278 -13.9933 +499 1 17.7218 3.13981 10.7749 -4.33552 13.9915 6.34554 +500 2 18.6231 3.34836 11.0663 1.21144 -2.68719 -3.11144 +501 2 17.734 2.28626 10.3485 2.99182 -14.4528 -5.38806 +502 1 12.2792 18.655 10.1327 17.2693 -45.8263 -15.1364 +503 2 11.5058 0.449575 10.4425 -26.2107 18.2097 8.79889 +504 2 13.0094 0.611642 10.1232 12.3896 24.8189 4.81349 +505 1 10.4214 9.73086 12.5154 -11.4047 -1.1898 4.78042 +506 2 11.1516 9.87418 13.1364 2.96428 -4.00819 -1.03044 +507 2 10.2474 8.77319 12.4992 9.30457 6.64045 -3.3636 +508 1 0.651598 2.68478 7.18172 -17.9134 21.5061 -11.8097 +509 2 0.347525 3.6016 7.34273 5.69642 -14.867 -2.54197 +510 2 0.849668 2.34638 8.05251 8.91351 -8.30419 8.52406 +511 1 0.318497 15.272 6.90444 -3.43175 -0.902574 -18.2314 +512 2 0.478582 15.5644 7.78858 6.40513 2.68345 23.4663 +513 2 0.623162 14.3599 6.89897 0.272636 -4.92753 -7.69196 +514 1 17.0533 6.94572 15.0273 7.81631 0.565766 -0.894277 +515 2 17.8128 7.55845 14.958 -6.36521 -5.11302 -0.197876 +516 2 17.4132 6.11744 15.3876 -1.58799 4.21551 0.905627 +517 1 9.15046 12.5368 8.00027 -36.358 14.0028 8.44058 +518 2 9.59383 11.9142 7.43445 3.21629 -19.4527 -15.2125 +519 2 8.22229 12.648 7.66907 25.8785 -7.47424 5.38289 +520 1 1.16102 1.67919 2.79298 -14.264 -19.5534 -4.4961 +521 2 1.06769 2.21394 1.99483 -1.93616 3.76767 1.09072 +522 2 1.84572 2.00753 3.35812 13.0572 19.5695 8.60311 +523 1 4.13351 15.1441 9.8761 6.18483 -5.86151 -6.61306 +524 2 3.91524 15.1965 8.93344 2.62784 3.42174 0.908977 +525 2 5.03514 14.7702 9.87632 -7.63961 1.62567 3.94135 +526 1 7.3909 2.2738 14.7748 9.28558 9.05007 -9.33433 +527 2 7.12441 1.5503 14.2057 -1.53405 -3.63662 -1.19206 +528 2 7.87829 2.88836 14.1809 -18.0097 -8.54319 17.0088 +529 1 18.3492 14.5565 2.15246 12.0934 24.362 7.12212 +530 2 0.551729 14.8667 2.53499 -6.69921 -6.84856 -6.85574 +531 2 17.7888 15.364 2.12839 1.3753 -15.6354 -3.85708 +532 1 10.0163 2.6808 12.9164 -0.493731 -5.11601 -9.40492 +533 2 9.92018 2.0572 12.1601 0.76191 10.4011 8.73608 +534 2 9.26265 3.29452 12.869 4.65507 -2.10266 -3.09911 +535 1 2.95427 8.9021 13.1034 24.5728 -3.04867 -5.91166 +536 2 3.51177 9.68096 12.817 -20.8286 -16.9148 9.19061 +537 2 3.59809 8.18481 13.2917 -7.73525 14.463 -2.49767 +538 1 3.26448 8.6069 3.78485 -10.2248 -21.121 34.5648 +539 2 3.76672 9.19042 3.24166 13.0731 20.305 -12.8555 +540 2 3.48359 8.83627 4.72374 -5.93153 -5.30867 -25.3462 +541 1 5.8473 7.24819 8.6208 2.3932 7.90906 9.86277 +542 2 5.81432 6.28497 8.53212 -5.5277 -2.57364 -0.635967 +543 2 5.0659 7.54439 9.12071 1.08185 -7.49096 -4.29671 +544 1 14.8764 1.57981 1.83846 12.2497 10.4795 -14.7641 +545 2 15.1104 2.2908 2.43504 -9.02026 1.90223 13.0204 +546 2 15.3525 1.8445 1.03212 -8.04537 -15.132 5.23431 +547 1 8.61698 15.0264 0.696156 7.89205 -2.64916 2.43147 +548 2 9.41092 14.8348 1.25307 -18.4618 8.30064 -5.38467 +549 2 7.89576 14.464 1.0316 3.03152 0.23278 2.41128 +550 1 15.4513 1.4301 7.20503 6.99627 -6.82188 0.69389 +551 2 14.8244 0.90582 6.69357 -2.8394 0.789398 0.0418873 +552 2 15.0149 2.26607 7.38205 -7.95005 6.31947 4.24803 +553 1 4.96675 12.927 18.445 -0.392058 -1.0762 11.0005 +554 2 5.34886 12.9244 0.695922 -4.30965 1.19363 -4.30526 +555 2 5.68 13.266 17.9034 2.74534 3.65082 -4.88489 +556 1 15.3953 8.66034 18.0902 -2.07624 -16.7815 -3.18775 +557 2 15.9144 9.19311 17.4724 -5.66293 4.97787 2.21077 +558 2 15.1583 9.22886 0.188985 2.48846 7.45062 3.31632 +559 1 12.0359 3.11648 18.28 -8.04977 7.84102 -5.19135 +560 2 12.2901 3.11968 0.565205 5.43673 -10.4163 -2.44039 +561 2 12.4787 2.41139 17.7764 2.20222 0.638625 8.9068 +562 1 13.1884 12.6911 5.14611 -2.25763 -6.31837 -0.123489 +563 2 13.4652 11.7849 4.90596 3.78769 10.9202 3.38983 +564 2 13.3386 12.7839 6.10454 1.74722 -2.69816 -5.37077 +565 1 6.12211 7.19464 0.152335 -0.889801 -16.5081 12.3486 +566 2 6.2475 8.12337 19.0248 -9.08967 1.02729 -5.81202 +567 2 5.35557 6.85974 0.666933 3.80599 9.00251 -10.0268 +568 1 17.6814 15.8746 14.896 -32.95 0.345881 -9.96463 +569 2 16.7135 15.9334 14.9982 15.4899 6.1636 11.5551 +570 2 17.7111 15.6936 13.9484 19.9419 -0.275145 -3.25111 +571 1 13.1284 0.88699 16.7751 -4.95458 6.20661 5.10718 +572 2 14.0638 0.660956 16.7688 7.30918 -0.228866 0.981928 +573 2 12.6898 18.6827 16.6682 -2.70263 -7.7996 -4.366 +574 1 10.8711 14.4993 7.46323 15.7126 -17.3597 -1.2585 +575 2 10.128 14.0173 7.85917 4.58757 6.56369 -3.56814 +576 2 11.6082 13.8461 7.48059 -10.4237 16.2655 0.791757 +577 1 17.6751 8.40087 2.13849 -13.7675 10.6042 3.42109 +578 2 16.7708 8.37025 2.51335 11.2555 0.423493 -3.0905 +579 2 17.6147 7.881 1.33167 1.95975 -7.58305 -2.5048 +580 1 12.424 7.82566 2.03348 6.80204 18.2298 -3.36389 +581 2 12.2928 8.74872 1.74157 -3.31877 -9.32949 5.70746 +582 2 11.9673 7.27395 1.39444 0.405274 -3.29714 -11.9602 +583 1 12.0088 14.6056 10.3972 49.4943 -15.6831 -19.0447 +584 2 12.4654 14.316 9.56616 -19.1829 7.51475 23.0356 +585 2 11.0956 14.6861 10.1978 -35.275 4.57666 -6.07844 +586 1 6.81054 6.90501 15.534 -24.6279 -1.31201 9.93627 +587 2 7.70831 7.14913 15.3109 11.0416 1.99651 0.427612 +588 2 6.48555 7.50951 16.2192 7.91049 -4.43387 -1.91407 +589 1 7.94039 4.47545 13.2332 14.4982 34.8647 21.806 +590 2 7.26408 4.6474 12.5684 -6.44209 3.92223 0.968251 +591 2 8.05746 5.34482 13.7439 -3.25809 -36.365 -21.9094 +592 1 13.3499 12.2014 14.3127 -1.24116 1.37617 13.1465 +593 2 13.3241 11.2332 14.3368 -6.04942 0.470969 -4.28371 +594 2 13.6308 12.4336 13.4212 3.90264 0.498209 -3.09495 +595 1 14.5954 9.45997 7.28998 13.2192 -1.86441 -1.0042 +596 2 15.4197 9.90762 7.5754 -11.2574 0.0534663 -4.99205 +597 2 13.8535 9.8793 7.72336 -3.17401 5.05716 8.17378 +598 1 12.6619 16.8656 3.26711 -0.0867316 -13.7478 -1.21165 +599 2 12.9036 17.3981 4.01825 1.80146 10.547 8.89773 +600 2 12.7645 17.4143 2.493 -0.0316456 12.4477 -7.66427 +601 1 1.00141 7.10091 17.3455 15.3286 -2.27437 -0.63111 +602 2 0.197357 6.73674 17.6796 -23.7065 -4.2556 16.6559 +603 2 0.696205 7.72166 16.6912 7.12828 11.4292 -16.7267 +604 1 12.984 4.84784 15.752 -30.1278 -7.6986 -1.85236 +605 2 13.773 4.32613 15.627 12.1969 -0.534485 4.03194 +606 2 13.2127 5.76882 15.785 16.3015 19.3583 1.60965 +607 1 2.35806 3.40155 5.13736 7.00458 -19.3644 -43.6846 +608 2 1.86996 2.9687 5.81855 -13.4119 -5.52905 24.958 +609 2 2.73401 4.18924 5.49805 8.9837 23.3098 13.0491 +610 1 8.19273 10.9521 13.6844 -8.81681 4.64201 23.2716 +611 2 8.19092 10.7627 14.6526 -0.424045 0.881441 -21.4162 +612 2 8.95149 10.4932 13.3231 15.2004 -1.23984 -4.72202 +613 1 13.0449 1.52469 13.2577 -17.2068 8.30684 11.3152 +614 2 13.5293 1.59874 12.4201 -3.55841 -0.219514 3.90721 +615 2 12.4208 2.28784 13.3343 18.9425 -17.4385 -9.09999 +616 1 6.61166 13.6023 2.12464 -9.14589 11.0627 -26.7302 +617 2 6.03511 14.0379 2.75872 -4.67031 1.02227 7.02539 +618 2 7.1693 13.0213 2.62577 8.97168 -8.12604 14.3361 +619 1 15.8326 6.37868 12.5447 13.0084 18.5244 20.7727 +620 2 16.3675 6.96965 11.9727 -5.6566 -10.5049 5.53461 +621 2 16.1589 6.56267 13.4684 -3.25982 -7.33208 -24.589 +622 1 16.7829 0.679169 9.53725 3.65315 -1.00951 10.2573 +623 2 16.653 18.4141 9.83094 1.34292 -7.75704 2.15353 +624 2 16.269 0.772043 8.73148 -3.87084 4.41009 -12.8197 +625 1 6.12871 11.643 8.2509 28.8456 37.0564 -10.7514 +626 2 5.32101 11.4251 8.67159 -25.2961 -16.2243 16.4685 +627 2 6.59615 10.8374 8.068 1.48557 -20.4229 -4.39625 +628 1 2.81588 8.6455 0.385911 -12.1168 -14.4708 -15.8933 +629 2 2.2408 8.27575 18.315 12.5525 5.70225 18.3425 +630 2 2.25296 9.2478 0.88122 -2.81952 5.7616 1.15354 +631 1 10.1112 10.3249 6.56463 -6.88185 10.2676 4.3595 +632 2 10.6724 9.72741 7.0699 2.3169 -7.24343 0.885556 +633 2 10.4905 10.3984 5.68005 1.7842 -2.70629 0.197339 +634 1 6.85117 15.7741 6.71172 -4.51814 -4.38518 8.0947 +635 2 7.10947 16.276 7.50071 -0.280141 -2.70051 -1.05147 +636 2 7.0022 16.3747 5.97143 2.95927 2.8361 -5.64101 +637 1 6.55245 12.8624 5.85582 3.66478 4.31955 2.99752 +638 2 6.71899 13.7301 6.24424 -0.933807 5.79026 -3.46681 +639 2 6.12481 12.3549 6.55179 0.263982 -0.200358 2.15574 +640 1 16.7435 12.5401 9.7846 -13.9618 -8.21713 16.7649 +641 2 16.8388 11.8663 9.10427 2.99064 0.578166 -4.74348 +642 2 17.1608 13.3339 9.48085 7.01955 11.3182 -8.14386 +643 1 6.27773 2.82725 2.7475 -16.1332 4.52919 -16.5002 +644 2 6.37029 3.76301 2.48637 6.52487 -6.75351 6.59876 +645 2 5.7241 2.45518 2.0296 8.37538 -0.331655 9.00677 +646 1 10.7419 2.97566 3.2545 -3.93098 2.36946 -8.35386 +647 2 10.3631 3.83794 3.45313 -5.44824 -1.84651 0.91029 +648 2 10.2755 2.65841 2.45654 4.06882 -1.04864 5.83378 +ITEM: TIMESTEP +90 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.80968 6.6261 17.8375 -14.5778 0.995444 8.41947 +2 2 7.95772 6.60642 18.3334 15.3437 1.8775 -14.2431 +3 2 8.74654 5.99095 17.1112 1.57504 -1.57025 6.7209 +4 1 0.142832 8.36014 6.73441 10.0116 -15.4349 27.0014 +5 2 0.232649 8.20449 5.79462 4.11725 -7.32768 -11.6468 +6 2 0.67494 7.65251 7.20998 -18.6261 25.5606 -16.1468 +7 1 8.65703 0.380136 6.98192 16.3005 -1.0776 2.50655 +8 2 9.57515 0.309779 6.66722 -10.0942 0.994659 4.05519 +9 2 8.27212 1.03395 6.395 -6.58679 0.322126 -3.42087 +10 1 6.47941 1.69165 11.7468 2.00503 -21.4393 -6.03474 +11 2 5.9725 2.29393 12.2744 -13.1143 10.2157 7.12378 +12 2 5.89376 0.920881 11.5936 7.71629 6.15291 -2.33076 +13 1 6.9103 5.50063 2.38437 -35.7814 23.4203 2.69428 +14 2 6.20944 5.92743 2.96221 29.3961 -15.7919 -7.47581 +15 2 6.73166 5.94071 1.53167 10.6635 -7.16691 8.95661 +16 1 16.211 10.2361 16.1124 -22.7966 -2.93172 13.0323 +17 2 16.937 10.2632 15.5246 28.6916 5.0146 -15.8412 +18 2 15.9737 11.152 16.3021 -3.36115 -0.429235 -4.16748 +19 1 10.8196 14.9788 2.33309 -6.31813 -9.42536 4.48609 +20 2 10.7437 14.525 3.19227 -2.25161 -0.175376 -6.3843 +21 2 11.168 15.8375 2.56675 6.6431 8.63317 3.56201 +22 1 17.1655 8.21466 10.9616 20.3007 -11.9207 -19.649 +23 2 16.6876 8.89778 11.4174 -14.8371 14.2918 8.905 +24 2 17.9353 8.67496 10.5709 -5.82559 -3.7293 4.59063 +25 1 14.5981 15.9748 16.3536 13.4587 -18.0704 19.8012 +26 2 13.6875 16.2688 16.3636 -10.2246 8.72504 -7.33216 +27 2 14.6733 15.4751 17.2031 2.63957 5.2712 -15.5493 +28 1 12.1292 13.2811 0.580093 14.6523 -12.0599 13.1814 +29 2 11.875 13.3883 18.3092 -10.372 6.98394 -12.7652 +30 2 11.639 13.8901 1.1449 -2.74566 6.59249 -3.74219 +31 1 9.34925 5.48981 3.82539 12.3818 -0.191077 28.8485 +32 2 8.80634 5.44704 4.61652 7.17551 -1.92534 15.5524 +33 2 8.65833 5.42982 3.20736 -26.4153 -0.989629 -43.3837 +34 1 1.57757 3.9189 11.5719 -21.368 33.8782 -18.8992 +35 2 1.50486 4.82423 11.9434 2.77 -7.29772 -4.79385 +36 2 1.95891 3.38097 12.2317 20.2106 -22.0339 29.781 +37 1 2.11583 6.92705 8.12278 -10.2704 -2.23476 -15.4196 +38 2 2.47676 7.42607 8.85663 6.65774 -1.70501 8.2798 +39 2 2.06913 5.99576 8.38149 2.03129 -2.32531 8.57063 +40 1 5.2846 4.43559 7.83749 -11.1092 26.0267 -7.92074 +41 2 5.42959 3.50305 7.74019 3.58921 -20.4287 3.63869 +42 2 4.59753 4.67739 7.1831 9.16507 -0.464339 6.41033 +43 1 3.36483 2.87842 17.4354 -5.48754 -0.0293267 11.8999 +44 2 4.0122 3.13798 16.7945 16.5223 13.9802 -16.1706 +45 2 2.91387 3.69111 17.7275 -1.08839 -5.27878 2.29607 +46 1 7.51128 5.54904 6.16479 9.71808 2.6671 3.00483 +47 2 8.12131 6.08033 6.71556 -9.69992 -1.44216 -4.10694 +48 2 7.04033 4.98631 6.78947 -1.48399 -2.17988 -0.0590646 +49 1 9.79239 7.0023 12.0333 -12.7203 -1.67256 -9.54047 +50 2 10.0574 6.1295 11.7028 -2.54946 7.94968 0.438659 +51 2 9.0334 7.28866 11.4661 15.1177 -5.87574 8.09476 +52 1 14.1269 3.84395 8.13857 -24.8841 12.3935 -19.8999 +53 2 13.4363 4.47719 7.80064 24.2741 -16.3277 6.83338 +54 2 14.3749 4.15432 9.00462 4.04893 6.4318 14.0535 +55 1 4.52686 17.2232 3.85531 -7.09571 -9.71268 16.0786 +56 2 5.35353 17.6803 4.02689 3.89364 6.28665 -2.88462 +57 2 3.96567 17.7155 3.24673 4.45666 4.6431 -9.26961 +58 1 16.1958 16.5107 10.5377 18.4287 -13.9772 -31.1199 +59 2 15.4454 16.6557 11.0933 -16.6117 1.05393 13.9092 +60 2 15.8645 15.9242 9.81336 4.55855 15.7974 16.2758 +61 1 1.967 4.85121 0.0645769 9.40837 -19.0171 0.778776 +62 2 2.73793 5.10942 0.56616 3.15966 4.76786 17.0447 +63 2 1.80075 5.61055 18.1709 -12.801 18.3624 -15.2179 +64 1 11.1737 13.314 16.4367 2.74473 1.78814 5.72217 +65 2 10.7128 12.4641 16.5748 8.32361 2.87799 -7.58216 +66 2 11.8417 13.1969 15.7431 -5.18043 -7.14508 -0.417807 +67 1 10.0458 10.8999 16.8205 33.4394 -5.51473 9.19041 +68 2 10.5428 10.0531 16.9406 -15.1708 22.1127 -3.77119 +69 2 9.12902 10.6892 16.7607 -22.7906 -6.8787 -3.44008 +70 1 11.889 17.5084 13.4814 3.48745 6.24304 -13.0003 +71 2 12.5913 17.1622 12.8998 -9.91022 -4.16273 6.93206 +72 2 12.0139 18.4633 13.4204 2.43964 2.21886 2.73389 +73 1 6.44228 9.49569 12.2996 9.71147 -12.8692 -34.1322 +74 2 7.06965 9.17025 11.5988 -17.7592 6.4035 17.1392 +75 2 6.97144 10.0526 12.8659 4.91959 6.23922 4.73193 +76 1 16.3022 12.832 2.75135 -12.5209 9.65366 -4.24277 +77 2 17.1598 13.1655 2.44684 -4.70434 0.462679 5.46936 +78 2 15.6996 13.6248 2.74248 12.9928 -20.5688 3.1232 +79 1 0.706696 12.7395 5.83755 -10.6776 2.47735 15.1944 +80 2 1.02688 12.9731 4.95908 -4.07327 -10.4263 -9.29508 +81 2 18.3891 12.5308 5.80039 14.5368 6.4085 -10.1514 +82 1 5.29875 16.3254 18.4501 12.7507 -5.44046 -6.67673 +83 2 5.72604 15.6129 17.9385 -8.69196 7.59677 5.8406 +84 2 6.01274 16.6418 0.375909 -8.3334 1.51688 4.30584 +85 1 0.743878 7.68205 4.10167 -26.7478 -30.2572 33.4946 +86 2 0.179417 7.92019 3.37827 -7.5716 9.21403 -16.4097 +87 2 1.60385 7.98113 3.89879 36.269 17.899 -12.2731 +88 1 3.22103 9.09598 6.53924 -28.7289 15.6764 -27.4701 +89 2 3.63534 8.61301 7.2251 9.03881 -15.9481 23.3571 +90 2 2.25678 8.88215 6.53178 21.3431 5.76786 5.41461 +91 1 7.2773 10.3926 16.241 -1.60955 -9.9776 11.4431 +92 2 6.63502 11.108 16.2935 -0.090439 -0.440245 3.15105 +93 2 7.09074 9.80627 16.9963 -3.87073 10.8392 -3.46734 +94 1 11.0095 0.891279 5.03438 2.23591 -17.8064 16.3849 +95 2 10.8775 1.7336 4.57918 5.69275 -3.07397 -7.72854 +96 2 10.7003 0.188666 4.43596 -0.931337 13.9517 -3.17827 +97 1 4.21583 2.94335 13.1635 9.62289 2.41259 16.4284 +98 2 4.47922 3.3428 14.0131 -5.18172 -0.255184 -10.0037 +99 2 4.1364 2.00091 13.3783 -2.2119 -1.88246 -4.82143 +100 1 8.45625 10.2801 1.81127 9.01648 -22.0588 9.24648 +101 2 8.30671 10.8697 2.54783 -2.77767 16.2884 7.52121 +102 2 8.66335 9.4444 2.27657 -0.852681 8.00384 -10.6723 +103 1 10.2261 1.659 15.4538 -6.06042 8.31352 -11.6288 +104 2 11.1361 1.48308 15.6359 20.1952 -3.56794 7.64131 +105 2 10.2187 1.98601 14.5369 -5.79366 -2.30068 5.3707 +106 1 2.60435 12.742 7.94637 -6.15341 0.568057 0.983218 +107 2 3.03975 13.5699 7.72118 6.64853 3.0435 -2.79803 +108 2 1.95513 12.6117 7.24141 1.86204 -3.09485 1.26562 +109 1 3.88579 11.7956 5.01149 -19.6155 -13.0634 1.96641 +110 2 3.74363 11.1082 5.69355 0.727972 11.568 -8.07528 +111 2 3.05901 11.8342 4.47209 17.5209 1.69759 11.0979 +112 1 6.76239 14.55 16.9383 -0.403452 -2.75277 4.08609 +113 2 7.61561 14.9826 17.0312 2.52456 -1.29817 -0.221044 +114 2 6.44911 14.7692 16.0549 2.09428 -3.60588 -3.74869 +115 1 14.1942 14.5231 3.16652 -5.12336 -14.4242 4.12891 +116 2 13.6899 15.3256 3.31261 0.149267 9.23779 -5.23449 +117 2 13.7696 13.8761 3.7521 4.09464 2.97302 0.255936 +118 1 8.7401 18.0877 16.1157 -15.0544 -15.1521 5.72203 +119 2 9.42706 17.4939 16.3945 -6.08837 -23.732 7.70311 +120 2 9.27218 0.11536 15.7481 8.35971 40.209 -14.9349 +121 1 4.63391 1.71898 4.89 36.0507 -5.82478 -13.0459 +122 2 3.81997 2.19927 4.85319 -16.3674 13.8452 0.00946397 +123 2 5.20292 2.04685 4.14723 -16.8402 -3.94878 19.5369 +124 1 15.0105 12.65 16.5031 22.0082 2.89039 39.0948 +125 2 14.6032 12.5883 17.4132 0.919275 4.87615 -33.2046 +126 2 14.3966 12.5461 15.7793 -22.8851 -3.84554 -8.75239 +127 1 15.7197 18.424 16.8504 13.0838 27.0964 8.25258 +128 2 16.3964 18.519 17.5419 -1.36847 2.51381 -4.544 +129 2 15.6686 17.4972 16.714 -13.5977 -31.6712 -2.03374 +130 1 1.39308 1.32386 16.6798 -9.07755 4.26299 3.83254 +131 2 2.19455 1.8573 16.8358 -13.1892 -10.0845 0.867767 +132 2 0.760663 1.62622 17.366 11.6728 -4.82483 -8.86289 +133 1 18.2416 4.3099 15.966 -4.36834 -5.16176 -14.6355 +134 2 17.7783 3.61219 15.465 8.57404 10.6893 6.25867 +135 2 0.425079 4.50442 15.5034 -5.04787 -4.14191 4.79432 +136 1 12.0688 17.0582 16.1192 -6.60497 -5.44285 54.7429 +137 2 11.374 16.6436 16.7154 18.2098 8.22439 -32.524 +138 2 11.7541 17.1189 15.223 -7.97888 -4.44492 -17.7493 +139 1 16.0987 2.72798 18.2222 -6.94033 2.52412 -3.34156 +140 2 15.6657 3.49187 18.6187 5.88163 2.98889 4.51464 +141 2 15.8079 2.8031 17.3159 -2.77048 -8.0731 -14.4365 +142 1 6.58612 13.762 10.0351 1.63352 -0.32404 13.73 +143 2 6.39624 13.3299 10.8846 2.34483 4.77487 -0.634471 +144 2 6.55421 13.0562 9.39028 1.369 -6.64332 -8.7831 +145 1 10.1169 18.5721 2.70869 27.9004 -1.02691 -4.20355 +146 2 10.7561 0.140951 1.98734 -15.1054 -0.137902 13.7961 +147 2 9.28626 18.3596 2.30468 -14.2521 -4.05351 -7.65243 +148 1 3.07988 17.6804 6.1902 -35.1734 2.13391 -17.3705 +149 2 2.15682 17.7525 5.8242 24.0448 -4.32039 20.662 +150 2 3.55195 17.7661 5.36197 20.4585 -2.58277 -0.69289 +151 1 12.6061 16.7775 7.89366 1.16584 -8.73771 -17.6522 +152 2 11.856 16.1922 7.7211 -0.763759 -4.24653 -1.89641 +153 2 12.3057 17.3353 8.59898 -2.13454 17.8975 18.5826 +154 1 14.8965 15.3132 8.35277 -22.4274 15.9599 0.214205 +155 2 14.2421 15.9941 8.02515 16.4945 -20.4059 13.6979 +156 2 15.4898 15.1572 7.61828 5.37632 7.31151 -11.1374 +157 1 17.8957 18.2766 0.201476 9.69326 -17.5267 -0.973127 +158 2 18.6995 17.7195 18.781 -12.0492 3.04369 -7.3597 +159 2 18.2321 0.401263 0.645934 -1.5685 17.2308 6.22008 +160 1 0.802158 10.4818 1.45184 -19.0828 -29.4994 30.4216 +161 2 -0.0309651 10.0246 1.77565 29.2477 9.1244 -14.7118 +162 2 0.53478 11.1455 0.834437 -7.87366 18.9841 -18.3051 +163 1 1.85308 12.2863 3.27351 -7.97315 5.10175 -10.2215 +164 2 1.42551 11.5849 2.74616 7.16023 4.54594 2.45335 +165 2 2.09673 12.9814 2.63054 -3.38314 -5.43944 9.55244 +166 1 0.718881 17.2977 4.9616 -19.2906 6.0419 1.76293 +167 2 -0.10575 17.7685 5.12875 8.39755 13.2462 -10.2288 +168 2 0.622971 16.5645 5.55208 6.7728 -21.2776 10.1703 +169 1 1.03867 0.919889 9.35844 3.74022 -6.32288 33.4729 +170 2 1.10918 0.592533 10.3007 6.31379 11.0803 -22.721 +171 2 0.269914 0.464458 9.03134 -8.6906 -2.38217 -7.04515 +172 1 16.7862 2.42581 13.3986 14.7457 27.0937 -15.311 +173 2 16.9847 2.74906 12.4891 -5.29709 -2.40963 18.2684 +174 2 16.5429 1.52129 13.2791 -8.06021 -27.7395 3.47759 +175 1 2.69738 16.0066 12.0777 13.1506 -14.7233 12.6976 +176 2 3.02715 15.5922 12.9029 -9.51867 9.47826 -13.4594 +177 2 3.28974 15.6737 11.3809 -2.31502 2.53439 -1.78657 +178 1 16.3754 15.4917 6.11201 -7.25585 -20.1131 3.67265 +179 2 17.3156 15.5044 6.29369 9.86882 2.22778 5.36532 +180 2 16.2073 16.2228 5.51797 -0.959992 10.1027 -9.31738 +181 1 5.7174 5.24337 11.7813 4.42707 -14.1004 -1.48072 +182 2 5.44277 5.99707 12.328 1.64183 -4.11158 -2.88134 +183 2 5.22325 4.47043 12.1002 -4.92771 7.03451 -4.06757 +184 1 15.1242 4.92712 0.766674 18.5408 -12.9138 10.3204 +185 2 14.9855 4.62556 1.67944 -3.08744 4.9541 4.0864 +186 2 14.3291 5.35182 0.492873 -21.4444 10.4963 -5.72763 +187 1 16.3798 16.4926 1.83048 25.9496 20.3657 -34.7081 +188 2 16.3432 16.8093 2.72897 -9.33108 7.61853 14.7037 +189 2 16.7914 17.2408 1.28765 -16.0156 -28.1785 20.3541 +190 1 0.157471 4.87182 3.99278 -9.81132 22.7056 -3.03191 +191 2 0.5332 5.76253 4.03054 -8.2904 5.08609 0.673103 +192 2 0.911036 4.31937 4.01308 22.6258 -22.4944 4.73784 +193 1 2.97603 15.0857 15.1688 -3.76699 16.0764 -9.28303 +194 2 2.87698 14.8354 16.0845 -1.20729 -14.2266 12.1787 +195 2 2.48786 15.9266 15.1702 1.40562 1.39337 -6.33902 +196 1 1.10637 14.6846 9.51596 31.8836 22.2572 14.4694 +197 2 2.01065 14.9183 9.89233 -34.4229 -12.9306 -18.6629 +198 2 1.03031 13.7317 9.56194 1.94445 -7.79278 4.16037 +199 1 13.55 16.5172 11.5597 10.1041 14.0808 -3.72584 +200 2 13.3442 17.2549 10.9555 -5.19335 -6.01443 7.16005 +201 2 13.1025 15.7566 11.183 -9.96101 -8.306 -1.961 +202 1 4.75563 1.55237 0.702796 10.3802 -26.0161 11.0265 +203 2 4.32304 2.05314 0.014379 -14.7339 5.42124 -2.63334 +204 2 4.14265 0.839056 1.00315 4.15161 14.819 -1.07901 +205 1 1.52656 18.6416 11.9009 -8.95117 16.8483 13.4998 +206 2 1.43825 0.48402 12.7573 3.56637 -8.71242 -18.201 +207 2 1.98334 17.8196 12.0914 3.68072 -6.34965 2.55122 +208 1 11.4393 10.1383 4.17836 -13.7636 4.05009 -8.78245 +209 2 11.3903 10.5027 3.28707 -1.50281 2.58284 -2.63304 +210 2 12.3655 9.96172 4.28712 17.4192 -2.53267 8.67839 +211 1 8.18359 12.1636 3.86104 -21.222 -14.272 -14.5003 +212 2 9.05859 12.5239 4.0446 -0.40723 6.23371 14.3883 +213 2 7.56046 12.2135 4.62832 23.1203 4.46306 -6.77507 +214 1 14.593 4.04535 3.38111 7.28555 -5.40785 -19.1504 +215 2 15.2127 4.15408 4.10794 5.52844 2.67895 3.03112 +216 2 13.7536 4.35259 3.70606 -13.9578 6.65801 6.31365 +217 1 5.72323 1.65443 7.61073 34.4 15.7962 37.2038 +218 2 5.13785 1.03104 8.01585 -19.7408 -11.9782 7.15973 +219 2 5.42676 1.78462 6.74294 -17.7695 -4.7826 -52.6001 +220 1 17.8873 1.06414 4.83181 6.8154 -0.232455 -4.71432 +221 2 18.4369 1.21178 4.04718 -2.79964 -1.76243 2.38037 +222 2 18.3376 1.55744 5.53048 -5.83965 -0.882229 4.9581 +223 1 6.85055 9.23648 4.54341 6.32277 -8.10519 -4.82585 +224 2 6.75809 9.38079 5.49182 3.88959 4.29486 1.07151 +225 2 7.79379 9.02149 4.39148 -10.7358 1.98669 4.12637 +226 1 2.55801 14.782 2.06648 -8.35029 -12.2797 -25.7867 +227 2 3.24533 14.7191 2.71695 15.3489 0.778658 13.055 +228 2 2.98421 14.5338 1.22242 -9.03529 10.4097 12.3511 +229 1 17.2667 12.9721 13.1114 -20.9369 36.2303 -2.57416 +230 2 16.4188 13.4451 13.3365 18.5804 -22.1292 -0.415694 +231 2 17.7749 13.7311 12.7641 -0.529191 -13.9074 0.965338 +232 1 14.8416 10.5583 1.56689 -2.78575 22.6182 14.2458 +233 2 15.4799 11.2066 1.96334 -16.8252 -10.4846 -9.71145 +234 2 13.9405 10.9259 1.71943 20.5685 -8.6057 -5.43477 +235 1 5.6352 6.7176 4.51351 -9.14706 -11.8638 3.15016 +236 2 6.0003 7.60062 4.53525 2.53301 15.852 -6.04122 +237 2 6.16933 6.24394 5.16122 6.25334 -1.18144 -1.3834 +238 1 8.0084 8.26626 10.2701 -4.49752 14.9075 -15.7864 +239 2 8.53054 8.9292 9.77232 -0.437986 -11.1673 11.0277 +240 2 7.35426 7.95022 9.61336 5.97292 -3.64509 13.4454 +241 1 13.4616 18.4657 5.71166 17.1322 -6.35165 -5.45305 +242 2 12.613 0.202175 5.51075 -18.0122 19.0124 -5.00284 +243 2 13.2587 17.813 6.37409 -3.85709 -10.1746 14.3256 +244 1 0.0252945 2.56986 0.408061 0.439602 -5.22175 -5.84652 +245 2 17.7844 2.56336 0.0359587 -11.4993 -5.28871 3.98864 +246 2 0.277142 3.47535 0.26454 16.627 13.7372 -0.461998 +247 1 12.8639 10.8267 9.72576 -55.6075 31.3565 -11.278 +248 2 11.8723 10.9451 9.72713 30.8534 7.0313 -2.47663 +249 2 12.8724 9.89108 9.83244 20.4971 -22.7651 5.79467 +250 1 0.607625 12.2828 11.1117 24.514 -2.72666 -9.78403 +251 2 18.2964 12.3126 11.1603 -11.5713 5.22338 7.13378 +252 2 1.01642 12.6716 11.9034 -8.98148 -2.79725 -0.830812 +253 1 5.29539 7.3549 13.3064 -7.85772 10.5518 3.63543 +254 2 5.70599 8.16396 12.9287 -0.549664 -12.4206 10.9242 +255 2 5.67568 7.22584 14.1948 2.69835 3.31529 -9.72444 +256 1 1.17555 6.77844 11.9244 -33.9372 -12.3631 -14.3141 +257 2 0.259637 6.99751 11.6106 25.929 -3.06653 9.08527 +258 2 1.58097 7.60434 12.1643 7.59492 14.5493 8.35248 +259 1 15.5141 9.76806 12.4302 -1.8656 17.4266 8.04916 +260 2 15.0855 10.6363 12.2204 12.2826 -22.7347 2.36453 +261 2 16.0019 9.91808 13.2494 -6.58523 -0.731675 -3.13373 +262 1 16.4968 12.5534 5.50851 9.37615 -29.7593 -4.66799 +263 2 16.3074 13.4744 5.68685 -5.44524 15.7433 -9.11055 +264 2 16.3732 12.3531 4.54775 0.322938 17.9758 14.7603 +265 1 6.32376 9.8903 0.169934 -28.7401 -0.365509 -5.18995 +266 2 5.50824 10.2805 0.557378 14.6251 -5.00462 -6.15541 +267 2 7.04833 10.2225 0.694867 12.727 0.898893 11.9262 +268 1 12.1515 6.04661 4.01259 -24.0177 -36.8905 11.864 +269 2 12.231 6.67099 3.30768 1.42994 18.9462 -13.2923 +270 2 11.2548 5.64061 3.89367 21.868 15.3866 4.7403 +271 1 0.316109 12.8908 0.0158726 1.97018 -1.90411 4.82087 +272 2 18.784 13.4984 0.752127 -2.36898 -0.989285 -3.79 +273 2 18.4247 13.2164 17.9164 2.23727 -3.47257 5.47524 +274 1 3.55093 0.0615484 8.6771 30.4928 -5.90286 -4.02028 +275 2 3.49841 18.2151 7.84215 -7.8476 4.22576 -1.41638 +276 2 2.7473 0.557235 8.76228 -21.0031 4.54937 0.225707 +277 1 7.3901 17.5352 4.48573 6.23592 32.7201 -14.6481 +278 2 7.69571 18.4853 4.57976 -11.8279 -33.7706 3.32686 +279 2 7.33788 17.4402 3.51852 2.74261 -6.71083 9.2357 +280 1 9.25 17.16 12.2333 -3.7288 14.5824 3.61249 +281 2 9.26512 16.5009 11.5521 -3.80961 -18.6559 -12.0666 +282 2 10.1634 17.2094 12.5273 3.6148 1.53928 10.2644 +283 1 13.402 13.1082 7.90091 0.220655 -14.9059 29.302 +284 2 13.4302 12.436 8.64233 -5.21958 14.4877 -25.9571 +285 2 13.929 13.8525 8.23076 3.39805 -3.2421 -4.10773 +286 1 14.8025 2.90677 15.4495 23.2091 4.40575 2.70159 +287 2 14.1483 2.29946 15.1328 -14.8482 -16.0174 -4.02081 +288 2 15.4935 2.87296 14.7763 0.208871 3.12507 -3.30872 +289 1 9.90762 15.6519 16.9195 -4.56731 4.54647 -2.1455 +290 2 10.1638 14.7845 16.5964 9.48907 -4.21512 -5.5698 +291 2 9.51082 15.4442 17.7618 -6.39245 0.962418 13.4848 +292 1 11.1953 8.50068 16.6178 -6.68582 -9.72424 -8.69684 +293 2 10.4052 8.01271 16.3331 5.65618 1.52157 -2.37675 +294 2 11.7201 7.85843 17.0918 5.14472 -5.56789 7.7477 +295 1 3.97964 18.2216 16.8609 -11.5365 11.132 -5.80894 +296 2 4.44261 17.5481 17.3724 7.79342 1.98205 9.06349 +297 2 4.16759 0.471834 17.2017 1.31413 -17.4358 -0.663005 +298 1 2.27286 4.25928 8.9046 8.30035 -0.830932 12.3077 +299 2 3.22373 4.0264 8.87035 -15.4899 4.40379 3.11293 +300 2 1.97207 4.14495 9.83591 10.7423 -1.42059 -17.2737 +301 1 9.92348 10.3926 9.8203 -1.21029 -1.85278 -24.2235 +302 2 9.36782 11.1029 9.49607 0.630055 7.16446 -2.16893 +303 2 9.82869 10.3844 10.7566 4.49005 -1.30636 29.4196 +304 1 9.77911 0.915187 10.8241 -1.58049 4.53496 -1.50662 +305 2 9.30516 0.126632 11.1017 -0.152878 -7.87834 6.94802 +306 2 9.15539 1.38664 10.2518 4.51752 0.176684 -4.82426 +307 1 9.1489 15.1729 10.179 6.96198 -6.50551 5.53221 +308 2 8.91001 15.8322 9.53904 -4.06695 15.478 -9.20984 +309 2 8.38415 14.5913 10.1616 -4.75674 -5.76082 4.02117 +310 1 0.743465 9.68917 10.1631 30.9903 9.57445 -5.37239 +311 2 0.884314 10.6156 10.4664 -8.35327 -15.1374 -2.2352 +312 2 1.62506 9.41264 9.82336 -24.2866 3.90606 7.18729 +313 1 17.1113 4.7779 8.02102 2.26389 -23.2748 8.45538 +314 2 16.3418 5.309 8.21811 -5.84575 9.78705 2.38191 +315 2 17.0463 3.99595 8.60382 3.74785 14.695 -9.14029 +316 1 14.847 14.6269 0.171171 -19.7527 -14.4968 -14.2937 +317 2 15.5321 14.9161 0.755334 10.0132 13.2257 15.972 +318 2 14.1228 14.2968 0.729437 5.50655 3.69994 -2.14986 +319 1 3.90456 11.0507 9.5998 -4.69832 -0.998696 -0.0493525 +320 2 3.86255 11.1688 10.552 1.28841 5.10968 9.84865 +321 2 3.27063 11.6917 9.24194 0.0177884 -1.71993 -8.82733 +322 1 11.433 10.7439 1.41897 29.5023 2.97313 10.7876 +323 2 11.6019 11.6536 1.12948 3.85703 -2.03295 -2.25776 +324 2 10.504 10.6413 1.35913 -35.0433 -4.68689 -6.35229 +325 1 13.1835 7.21214 12.6412 -8.23521 -20.1104 -3.47812 +326 2 14.127 7.05932 12.5127 3.33109 -0.638199 4.03042 +327 2 12.8061 6.29857 12.6985 3.22225 19.9882 2.50286 +328 1 9.65928 1.95745 0.843925 10.2182 6.36996 -3.06277 +329 2 8.81763 1.63483 0.51897 -5.65357 2.11518 2.03686 +330 2 10.1334 2.26536 0.0610097 2.29468 0.231167 4.03759 +331 1 10.5974 13.4461 4.57973 -2.39764 -3.17335 8.92217 +332 2 11.4415 12.9723 4.66721 0.170993 3.79528 3.71784 +333 2 10.3828 13.7711 5.47244 5.6647 1.39651 -7.04866 +334 1 14.5805 1.64306 10.9903 3.01891 29.9103 -7.34195 +335 2 15.4206 1.31489 10.661 2.43812 -13.4824 -3.17866 +336 2 14.6923 2.61327 10.8523 -8.77415 -13.7688 6.87151 +337 1 14.4577 12.0498 11.5485 -29.7481 -1.24334 12.4997 +338 2 15.1787 12.3182 10.9897 13.6492 5.38623 -14.4259 +339 2 13.7324 11.7114 10.9784 17.3586 4.51945 3.50834 +340 1 8.16823 5.15587 9.894 -28.9634 21.8059 19.126 +341 2 7.25961 5.26999 10.2972 28.5921 -4.04796 -11.5402 +342 2 8.23961 4.23455 9.67377 -1.01689 -19.4985 -4.69706 +343 1 1.66839 17.0027 18.4477 20.9596 26.331 -27.2012 +344 2 2.19503 17.5247 17.7665 -16.8758 -18.2972 22.1195 +345 2 1.83767 16.0826 18.2308 2.67698 -10.8321 1.22526 +346 1 1.40907 17.4029 15.3161 -1.8056 14.8407 8.29727 +347 2 1.4134 18.2156 15.8633 3.96238 -8.68525 -7.97287 +348 2 0.471831 17.1989 15.2085 1.34275 -7.61847 -1.46046 +349 1 3.49459 5.75594 6.06077 -10.0958 -15.2551 6.44531 +350 2 3.00844 6.4276 6.56158 3.56089 -0.0685925 -1.76679 +351 2 4.03572 6.19023 5.40706 10.0519 13.1926 -8.23224 +352 1 12.6765 9.5142 14.2706 -5.75697 27.7722 -14.2581 +353 2 13.0673 8.79775 13.7668 1.15853 -14.5514 3.26719 +354 2 12.382 9.20431 15.1249 -1.95515 -14.6959 8.85488 +355 1 4.11243 15.2112 7.12768 13.4261 4.57048 -4.21166 +356 2 3.68336 15.9917 6.77855 -13.243 7.84695 -2.74865 +357 2 5.05149 15.4218 6.9541 -4.34911 -9.58911 5.5273 +358 1 0.807347 8.85082 15.1137 12.1653 -16.291 -5.21716 +359 2 0.579225 9.7725 15.0704 -11.1033 15.5539 4.56692 +360 2 1.61112 8.83255 14.5724 -2.7466 -7.45742 -2.63208 +361 1 12.955 8.28126 10.1315 4.47425 -26.4789 2.77461 +362 2 13.6724 7.69661 9.75218 -12.3213 15.4477 18.6624 +363 2 12.7996 8.04439 11.0766 12.5165 -4.13221 -14.8671 +364 1 15.2413 7.99312 3.46307 21.2061 37.6089 -22.4299 +365 2 14.4756 7.7211 2.94477 -5.95544 -17.8301 8.14742 +366 2 15.6187 7.46858 4.17258 -15.9179 -18.0198 8.83427 +367 1 17.1356 6.70525 18.6386 6.47512 25.7091 -12.2215 +368 2 16.6963 5.89525 0.233999 -10.309 -8.75159 3.76643 +369 2 16.4339 7.33237 18.3357 11.2115 -13.3479 10.1501 +370 1 8.91981 7.02641 7.93476 -17.5815 -13.9195 9.00305 +371 2 9.83812 7.25537 7.853 19.0031 7.73693 -0.560136 +372 2 8.849 6.45385 8.72921 -1.20537 6.38433 -11.1549 +373 1 12.4784 0.471427 1.2 -1.5382 -11.3036 2.52426 +374 2 13.1724 0.955828 1.65737 6.96212 2.95671 -0.139484 +375 2 12.8855 0.124586 0.40059 -1.81614 4.12295 -0.743523 +376 1 5.7338 15.0104 14.483 3.21537 -3.99883 -6.81615 +377 2 4.79914 15.0689 14.6899 -13.3072 1.49299 3.3932 +378 2 6.00174 15.8892 14.196 3.10174 7.95604 -0.192962 +379 1 3.73322 6.46389 1.74186 4.97145 -11.2752 -15.478 +380 2 3.41061 7.27444 1.33141 -3.85483 5.16021 2.72417 +381 2 3.71896 6.61791 2.68352 1.01313 6.07651 8.98471 +382 1 3.85612 11.3357 12.3214 9.74989 2.64833 3.1782 +383 2 4.70398 11.747 12.5616 1.03181 -4.89631 -4.08494 +384 2 3.21292 11.8498 12.8111 -10.0411 9.11388 1.93155 +385 1 5.31882 3.86098 15.7247 -14.6622 43.9235 8.42988 +386 2 6.03513 3.29574 15.4808 24.4173 -17.8012 -3.50674 +387 2 5.69837 4.77513 15.8552 -8.87612 -28.0013 -6.19005 +388 1 14.0506 10.0984 4.70507 12.9021 5.9963 -48.2497 +389 2 14.373 9.82203 5.54065 6.42583 -15.3441 32.1568 +390 2 14.6577 9.66966 4.04903 -16.6446 6.96016 16.1133 +391 1 7.63016 17.2999 9.07082 4.88589 -1.83029 4.08955 +392 2 7.05774 17.6443 9.76408 -9.77236 -5.61109 0.722829 +393 2 7.90646 18.0745 8.58282 6.82018 7.73796 -12.3688 +394 1 4.54853 14.4989 3.92298 4.51049 -12.0827 -19.4455 +395 2 4.48676 15.3439 4.34231 1.7531 23.2793 6.06498 +396 2 4.47875 13.8474 4.61218 -0.893081 -14.6097 11.9436 +397 1 14.1162 7.44072 15.859 5.72353 -2.97717 1.52707 +398 2 14.8925 7.45204 15.2793 -3.03398 0.324075 5.79835 +399 2 14.4079 7.84098 16.6936 -1.38652 -1.7593 -3.67135 +400 1 2.91046 18.3824 1.92161 -14.6763 12.8451 -3.99897 +401 2 2.56811 17.7851 1.23066 -1.64793 1.84374 10.7046 +402 2 2.14175 0.293363 2.23042 22.3557 -16.8939 -8.97037 +403 1 8.00583 1.57089 4.46736 31.4122 8.97246 -10.4438 +404 2 7.40416 1.98491 3.8452 -8.42929 2.78546 -1.25861 +405 2 8.8818 1.75969 4.05638 -17.375 -7.71187 12.4181 +406 1 2.50572 14.1939 17.7606 -21.3738 -1.77578 0.320632 +407 2 1.88811 13.4733 18.0291 6.14349 16.4853 -5.08899 +408 2 3.36784 13.821 17.8832 22.941 -11.7322 7.4453 +409 1 0.984409 1.95477 13.9081 14.9076 0.866869 -10.4657 +410 2 1.09683 1.70126 14.8211 1.02253 -2.39927 14.2505 +411 2 18.6933 2.04344 13.7674 -16.8072 2.56857 -0.576968 +412 1 4.29327 0.177122 13.8951 16.4248 3.49785 -13.6548 +413 2 5.17049 18.4046 13.9646 -5.43827 4.9033 -2.01246 +414 2 3.78721 18.4389 14.598 -10.2443 -5.04864 16.3534 +415 1 7.35353 0.990853 18.4538 -34.7507 -7.39683 16.7648 +416 2 7.55815 0.737816 17.5561 -3.16307 -6.20953 -15.156 +417 2 6.35665 0.974064 18.6083 33.4978 7.02218 -7.3799 +418 1 15.8311 18.4256 13.8966 -40.0758 9.01377 -20.0242 +419 2 14.87 18.5763 13.7207 27.6408 -4.60797 -2.68704 +420 2 15.8417 18.2976 14.8321 10.6174 3.57585 21.6768 +421 1 10.2864 4.58419 16.2444 -24.4222 -37.2091 -9.88285 +422 2 11.2299 4.68793 16.3674 13.142 -4.29349 -1.09379 +423 2 10.1171 3.59079 16.124 8.18179 40.05 5.52806 +424 1 15.8917 17.7071 4.46459 -20.0388 -20.4222 2.09772 +425 2 16.4651 18.4471 4.57513 18.3163 24.2221 3.8588 +426 2 15.0409 18.0029 4.83395 4.42355 -1.752 -6.47073 +427 1 6.88773 17.6166 13.9821 -38.4037 0.167583 13.1844 +428 2 7.46394 17.6315 14.7417 15.8748 3.42447 12.5511 +429 2 7.41699 17.4009 13.2391 27.9809 -3.71977 -23.5355 +430 1 13.1764 6.43911 6.52144 -5.83912 -0.258919 -12.4557 +431 2 14.0695 6.77261 6.34605 -1.47407 -3.35023 -0.470203 +432 2 12.7466 6.3372 5.63472 11.513 2.45032 19.1456 +433 1 7.86196 2.29978 9.4638 -2.97627 -2.7765 -21.1046 +434 2 7.31086 2.09746 10.2267 -8.88065 1.6173 3.7395 +435 2 7.37564 1.98398 8.66115 7.69705 6.95472 18.2428 +436 1 15.1916 14.7366 13.8236 -12.2847 5.72199 -1.13466 +437 2 14.8954 15.0381 14.6996 2.36081 -1.57038 -3.3629 +438 2 14.579 15.1371 13.1848 7.3504 -2.29354 4.97967 +439 1 9.39483 8.42303 3.86324 -21.5436 -11.8424 -10.9865 +440 2 10.2164 8.84977 4.07537 16.3384 7.87643 5.27894 +441 2 9.57157 7.47345 3.83359 1.44741 0.673327 1.03302 +442 1 17.655 13.5671 16.4489 -7.58846 13.4511 -15.7424 +443 2 16.7203 13.3469 16.3992 -7.59268 -4.18946 5.70215 +444 2 17.688 14.4057 15.9472 10.2114 -8.11811 3.61388 +445 1 4.94979 10.486 2.86622 25.3355 -10.7625 -10.0508 +446 2 5.84023 10.0991 3.03563 -22.0316 6.96347 2.01482 +447 2 4.71704 10.9487 3.67532 0.603793 8.46932 2.75775 +448 1 3.68042 8.39717 9.8747 -7.87972 -17.3414 17.5888 +449 2 3.759 9.34077 9.71499 3.24219 9.53521 -0.886609 +450 2 3.55014 8.28216 10.8428 3.92085 5.02512 -16.6805 +451 1 15.9973 6.92061 5.87772 4.82031 -5.03924 3.59177 +452 2 16.6812 7.41263 6.34454 2.21588 0.961055 0.440265 +453 2 16.3186 6.0008 5.83915 -7.41322 12.2727 -5.03736 +454 1 15.3004 7.2666 8.94213 -32.1238 -12.1179 -31.7334 +455 2 15.9839 7.55437 9.51768 24.5834 17.5628 17.3411 +456 2 15.1488 7.91682 8.21973 7.72693 -8.10504 16.1569 +457 1 6.21705 12.8062 12.747 -22.7002 13.2796 -10.093 +458 2 7.05571 12.494 13.0465 21.6431 -16.5072 9.89045 +459 2 6.01919 13.5682 13.3077 2.09027 1.41895 1.21426 +460 1 12.1299 4.57596 13.1432 22.4432 17.9492 20.1123 +461 2 12.1793 4.58175 14.1216 4.56317 3.76233 -12.2652 +462 2 11.3861 4.04706 12.9369 -26.6961 -18.2025 -7.73732 +463 1 11.4375 8.07047 7.90979 27.6542 -15.5792 16.7856 +464 2 12.1952 7.52933 7.56059 -23.0528 10.899 -6.13628 +465 2 11.6627 8.11033 8.86659 -7.72222 6.32108 -19.0792 +466 1 16.9453 10.7968 7.63148 -3.5821 -10.5143 21.6719 +467 2 17.6495 10.1525 7.46889 2.86773 -0.504685 -4.5375 +468 2 16.8108 11.3218 6.85057 1.29813 10.4979 -20.4226 +469 1 5.19425 18.0282 10.6847 0.056878 3.62778 8.77145 +470 2 4.66571 17.4143 11.2104 4.95394 3.09506 -2.12913 +471 2 4.57063 18.3664 10.0251 3.33377 -5.62986 -0.929046 +472 1 7.60987 17.4226 1.56636 -8.76834 11.2024 10.6057 +473 2 8.12097 16.6429 1.35059 3.07922 -5.96866 -14.3061 +474 2 7.62904 18.066 0.842261 4.5937 -2.56699 -0.219584 +475 1 1.93734 12.9421 13.6328 4.51097 2.01356 -10.2989 +476 2 1.33249 12.4003 14.1383 -4.04092 -5.16916 8.28012 +477 2 2.1441 13.7105 14.1828 3.43289 -0.0153047 1.69165 +478 1 9.36109 6.77295 14.8254 28.0404 -16.4025 -23.0383 +479 2 9.79586 5.92856 15.0909 -10.7826 13.1246 6.51236 +480 2 9.73683 6.91972 13.9197 -17.1545 2.79671 17.5547 +481 1 15.2759 4.38629 10.7467 0.911226 -10.0818 1.35121 +482 2 16.2063 4.08729 10.7712 -9.28003 7.88291 1.38983 +483 2 15.15 4.95989 11.5268 6.34994 -5.62458 -10.0329 +484 1 11.4488 6.21672 0.0274361 8.35139 15.4334 1.07365 +485 2 11.547 5.26836 -0.0918922 -6.12153 -5.65013 -4.62095 +486 2 10.5221 6.46299 18.5238 -1.7877 -10.3718 -2.04901 +487 1 18.4903 11.4194 14.9121 8.77287 -18.4144 -27.074 +488 2 18.1021 11.8559 14.1353 -5.2902 0.217957 4.39134 +489 2 18.3331 12.0271 15.6113 -5.23497 22.6985 22.6894 +490 1 7.12593 9.28496 7.31024 -23.9992 -6.07508 6.39318 +491 2 6.74279 8.45494 7.66169 4.89732 10.9664 -5.80838 +492 2 8.06011 9.1434 7.29118 23.2007 -3.69072 -2.70719 +493 1 18.3302 15.3588 12.1663 1.84912 0.0598217 5.47138 +494 2 0.628985 15.4631 11.9685 -1.01298 4.74778 -2.81479 +495 2 17.8359 15.8974 11.5264 -1.18931 -3.22386 -0.556154 +496 1 16.5345 4.36456 5.22425 -62.6276 -15.6665 42.2949 +497 2 16.4135 4.0372 6.15475 14.4043 4.47956 -24.0603 +498 2 17.4334 4.499 5.03806 48.2264 1.34274 -11.6623 +499 1 17.733 3.12037 10.7685 2.78093 13.2032 15.2159 +500 2 18.62 3.27348 11.1411 -3.87004 4.46435 -8.2182 +501 2 17.7411 2.21797 10.4818 -1.03268 -21.1847 -12.2715 +502 1 12.2988 18.6545 10.1426 21.4258 -12.4002 -10.8053 +503 2 11.5002 0.459945 10.3706 -28.4452 4.23152 6.39845 +504 2 12.9389 0.72089 10.1511 12.8533 4.08749 0.539844 +505 1 10.4313 9.72872 12.541 3.98701 -3.38274 8.58973 +506 2 11.1703 9.84044 13.1623 -1.01011 3.74187 -3.45859 +507 2 10.4039 8.77038 12.4204 -3.66163 0.188688 -4.07709 +508 1 0.615048 2.63664 7.2276 -9.26807 24.3162 -18.5585 +509 2 0.353188 3.56967 7.37092 2.19049 -16.4853 1.00686 +510 2 0.949026 2.32684 8.06684 4.15829 -4.72879 9.31366 +511 1 0.333537 15.2707 6.93805 -1.63763 -14.4268 -44.2284 +512 2 0.559673 15.3175 7.85021 9.94673 -3.51892 30.6084 +513 2 0.629693 14.3791 6.62643 -7.55161 17.6489 9.10591 +514 1 17.0527 6.91364 14.9743 11.0217 0.359412 -1.38417 +515 2 17.7989 7.54943 14.9113 -7.11537 -10.2599 3.19545 +516 2 17.3979 6.08953 15.3732 -1.90278 10.2985 -1.25317 +517 1 9.14167 12.5321 7.98456 -51.8007 8.58975 -7.36144 +518 2 9.48882 11.7504 7.57305 13.8522 -18.8219 -15.7166 +519 2 8.22261 12.6161 7.58551 34.0094 -0.937982 16.6367 +520 1 1.15656 1.63828 2.76743 -9.76481 2.77041 -4.10292 +521 2 0.864287 2.18836 2.03128 -7.19413 -5.97378 -5.55322 +522 2 1.70002 2.22125 3.28253 11.7483 7.29404 14.7886 +523 1 4.17339 15.1305 9.84913 -14.3711 5.0779 2.99988 +524 2 3.91961 15.3463 8.93389 10.9385 -4.50851 5.90843 +525 2 5.03476 14.6902 9.78793 -0.575875 2.49321 0.528438 +526 1 7.3951 2.27992 14.8377 -1.12966 16.8522 -8.99686 +527 2 7.16414 1.54106 14.2639 1.26623 0.276941 -0.531744 +528 2 7.65338 3.03331 14.2573 -5.05472 -19.0282 8.30824 +529 1 18.3172 14.5403 2.1483 15.3986 5.40572 3.08201 +530 2 0.535799 14.8642 2.50804 -16.0996 -1.12956 -11.071 +531 2 17.7238 15.3001 1.99479 6.48993 -0.927096 4.3539 +532 1 10.0475 2.68059 12.9077 -3.02015 -13.9614 -15.6621 +533 2 9.89167 2.00033 12.2018 7.6523 15.7956 13.7679 +534 2 9.26985 3.25658 12.875 1.66072 1.15674 0.355625 +535 1 2.93978 8.85687 13.107 17.7725 7.3386 -7.69378 +536 2 3.37522 9.71823 12.8547 -12.3312 -24.1388 6.15133 +537 2 3.67473 8.22279 13.2377 -8.38529 8.44125 1.12687 +538 1 3.27106 8.61507 3.79074 -8.49716 -38.7584 59.7131 +539 2 3.66196 9.22584 3.22278 26.3747 36.1018 -32.8858 +540 2 3.70281 8.77413 4.67945 -18.9434 -3.96308 -29.2422 +541 1 5.92777 7.2521 8.64891 -10.8881 -6.62505 3.42768 +542 2 5.84919 6.30478 8.465 1.79189 -1.90292 -1.42585 +543 2 5.07694 7.48175 9.0605 5.83384 2.94932 1.14829 +544 1 14.8827 1.64134 1.82872 -12.6885 -28.1567 -9.76357 +545 2 15.1087 2.39997 2.36476 0.314968 13.4446 -1.58597 +546 2 15.1034 1.73075 0.884031 8.80659 10.9019 15.543 +547 1 8.66156 14.9913 0.655877 15.6167 -4.79217 23.7466 +548 2 9.42437 14.9505 1.28455 -14.0351 0.988592 -13.753 +549 2 7.99981 14.403 1.0655 -3.22335 6.28365 -6.24421 +550 1 15.4067 1.46647 7.20695 -8.82589 -12.8718 -0.882757 +551 2 14.775 0.932663 6.69065 9.74374 4.52972 3.50353 +552 2 14.8641 2.16562 7.57814 -1.0399 11.0322 0.525673 +553 1 4.92475 12.8978 18.4559 2.19674 -3.23744 10.1082 +554 2 5.23586 12.8997 0.738081 -1.33722 2.66651 -10.6279 +555 2 5.70033 13.1343 17.9365 -0.0827318 6.23371 -0.0935372 +556 1 15.3819 8.68528 18.0932 8.72121 10.5448 -14.8557 +557 2 15.8142 9.23534 17.405 -7.78496 -12.8196 8.73029 +558 2 15.2566 9.31777 0.164984 -6.85428 -0.586954 10.5179 +559 1 12.0126 3.13082 18.276 9.47145 -1.72319 12.159 +560 2 12.2482 3.16999 0.564179 -5.55591 0.644277 0.165862 +561 2 12.5655 2.41012 17.9461 -5.90061 -0.236568 -11.7395 +562 1 13.2006 12.6959 5.14014 6.0546 -4.02499 4.06103 +563 2 13.6294 11.8271 5.0147 -6.69767 7.2237 -2.15456 +564 2 13.3727 12.9234 6.07289 -1.67526 -4.52376 -7.3865 +565 1 6.1651 7.14436 0.195504 -22.0894 -12.2339 1.18179 +566 2 6.12052 8.09409 18.9477 10.183 13.9972 -1.43251 +567 2 5.2591 6.87987 0.448218 12.567 -4.05161 -1.41715 +568 1 17.6881 15.878 14.8655 -1.85909 5.77814 22.6605 +569 2 16.7739 16.1608 15.0761 11.3822 -6.39517 -19.8211 +570 2 17.8371 15.675 13.9293 -11.1648 4.64831 -4.02463 +571 1 13.1067 0.88062 16.8301 -1.16362 5.09418 6.26073 +572 2 14.0188 0.56665 16.8428 4.80395 1.33473 -1.08149 +573 2 12.5822 18.7235 16.7479 -0.784604 -6.20947 -5.79489 +574 1 10.8701 14.5014 7.48366 30.6398 4.5327 -13.288 +575 2 10.1924 13.8927 7.76637 -8.27046 -6.89901 6.40521 +576 2 11.688 13.9665 7.40985 -13.0568 5.23738 5.47236 +577 1 17.7216 8.3975 2.13341 -5.03714 18.392 15.6468 +578 2 16.8261 8.35978 2.51012 1.26608 -2.81583 -3.60077 +579 2 17.7343 7.78208 1.41002 -5.68948 -14.3091 -15.2975 +580 1 12.4651 7.83121 2.02849 6.21002 21.8293 -0.701234 +581 2 12.2371 8.77742 1.88873 1.61752 -16.1639 -0.0618129 +582 2 12.1801 7.35781 1.23988 -4.06145 -2.69746 -4.32972 +583 1 11.9912 14.5504 10.3779 26.255 2.08103 -27.6641 +584 2 12.3772 14.5828 9.46952 -12.6474 -4.22617 24.8662 +585 2 11.0517 14.669 10.2537 -15.8484 3.20565 2.09431 +586 1 6.76727 6.87556 15.5462 0.393734 11.8444 22.477 +587 2 7.69535 7.12306 15.3658 -7.56189 -7.86407 -0.973014 +588 2 6.54154 7.32616 16.388 3.13619 -10.9433 -13.6985 +589 1 7.93405 4.43454 13.181 3.70457 37.9343 33.3332 +590 2 7.23909 4.66367 12.5613 -7.79541 1.00974 -8.53955 +591 2 7.95717 5.24214 13.788 5.6586 -32.0049 -23.1645 +592 1 13.3208 12.2124 14.3278 -1.85908 1.78375 8.34338 +593 2 13.1627 11.2597 14.246 -0.36998 0.633125 0.823702 +594 2 13.6236 12.4909 13.4584 3.579 0.31603 -3.71376 +595 1 14.5678 9.48203 7.30395 8.22624 -5.55489 -6.16459 +596 2 15.3274 10.0218 7.53849 6.73854 1.05081 2.13221 +597 2 13.8344 9.86252 7.77014 -14.2105 5.15772 9.40205 +598 1 12.6689 16.8584 3.2838 3.32354 22.4122 -6.02395 +599 2 12.8251 17.4603 4.02708 -0.185303 -8.85949 -0.0347213 +600 2 12.7374 17.4469 2.50984 -1.71014 -6.46341 4.85536 +601 1 0.984375 7.0735 17.3432 34.0501 -3.91376 2.11413 +602 2 0.125246 6.96907 17.7347 -25.3968 2.18392 3.09576 +603 2 0.950307 7.67775 16.5933 -9.77339 5.8232 -4.41721 +604 1 13.0022 4.84407 15.777 5.081 -10.3329 -5.56354 +605 2 13.7485 4.25418 15.5901 -10.0146 -2.33354 7.04552 +606 2 13.4521 5.67804 15.8535 -1.12386 24.7122 1.66863 +607 1 2.36131 3.40053 5.10919 -9.6311 -14.0051 -9.38531 +608 2 1.85776 3.14724 5.88615 -5.89279 -11.6191 4.05299 +609 2 2.64546 4.27356 5.34111 14.5219 19.3293 2.74972 +610 1 8.16093 10.9198 13.7208 -5.48668 -10.5203 36.1407 +611 2 8.01338 10.5218 14.6488 11.4544 18.6016 -43.3573 +612 2 8.9553 10.5154 13.3405 3.89898 -1.19123 3.66799 +613 1 13.0685 1.50992 13.279 -14.1832 25.7313 -25.8855 +614 2 13.6244 1.50815 12.4613 -6.9447 -4.36872 19.5281 +615 2 12.4297 2.25673 13.1075 20.3356 -25.0236 11.2619 +616 1 6.62047 13.6375 2.07221 -5.18984 1.0977 1.00923 +617 2 6.01355 14.0796 2.67998 -4.17105 4.32933 -3.39809 +618 2 7.10668 13.0566 2.65885 8.90022 -6.51269 2.26225 +619 1 15.8066 6.3469 12.5124 13.7748 11.2213 20.1038 +620 2 16.2844 6.87459 11.8544 0.57451 -1.64399 2.92177 +621 2 16.2805 6.52872 13.3684 -12.0243 -5.9969 -18.7155 +622 1 16.7622 0.649503 9.5351 11.3629 -0.534141 16.2257 +623 2 16.8233 18.3334 9.63984 -7.20854 -2.096 2.62458 +624 2 16.3504 0.825019 8.69009 -8.20455 0.909068 -17.3039 +625 1 6.16155 11.6721 8.23727 11.0478 -14.7079 4.32064 +626 2 5.37204 11.4355 8.7099 -18.5694 3.37101 8.66714 +627 2 6.52549 10.7898 8.06052 6.85938 7.24602 -7.48704 +628 1 2.80718 8.60686 0.397493 -27.1124 -12.7057 -15.0387 +629 2 2.16203 8.12721 18.4284 20.3601 19.9434 23.0266 +630 2 2.28863 9.2379 0.937046 1.66532 -5.5958 -10.4069 +631 1 10.1061 10.2794 6.574 -2.68384 6.39054 8.98367 +632 2 10.587 9.61275 7.07222 2.60765 -6.52577 4.24337 +633 2 10.6348 10.4062 5.77746 -5.53346 0.236498 -3.27199 +634 1 6.84319 15.7735 6.74802 2.92919 -7.52667 3.13791 +635 2 7.22287 16.2754 7.48672 -6.2609 -2.86584 0.474311 +636 2 7.16745 16.2182 5.95944 -1.73758 9.59963 -7.48558 +637 1 6.59004 12.8453 5.92771 5.9232 5.70246 -10.7633 +638 2 6.81648 13.7523 6.14266 -3.08056 9.02497 3.95142 +639 2 6.18071 12.4806 6.71128 -2.95494 -1.85994 5.08984 +640 1 16.7187 12.5557 9.81602 -6.97981 -8.42056 3.44329 +641 2 16.7367 11.9049 9.10465 3.04519 -4.31121 0.702836 +642 2 17.0063 13.3635 9.40922 2.88649 12.8114 -1.84814 +643 1 6.30344 2.78963 2.73877 -9.04367 -13.9111 -2.70816 +644 2 6.4136 3.72217 2.50807 2.58545 1.58307 -3.30667 +645 2 5.8765 2.3355 1.98292 3.38351 11.0448 5.4768 +646 1 10.696 2.92954 3.25253 -4.78239 0.546409 -3.48797 +647 2 10.285 3.77274 3.47459 -3.26512 -0.523652 -3.33277 +648 2 10.2907 2.61783 2.41902 1.90367 1.74508 6.25714 +ITEM: TIMESTEP +100 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.7952 6.55188 17.82 -14.0925 -19.7636 -3.75378 +2 2 7.88023 6.44026 18.1695 19.5523 6.07432 -5.80163 +3 2 8.99571 5.7855 17.2401 -2.64216 11.7935 9.74201 +4 1 0.13387 8.39658 6.71777 11.0686 -17.0219 51.8315 +5 2 0.297964 8.15416 5.82611 3.65759 -8.78146 -34.4276 +6 2 0.663997 7.73523 7.26654 -21.1289 27.238 -19.6589 +7 1 8.71966 0.469223 7.04147 6.63626 1.40123 -3.67752 +8 2 9.62406 0.435013 6.6778 -11.0722 1.83914 2.93454 +9 2 8.2146 0.970711 6.38506 4.19741 -2.20649 2.49068 +10 1 6.44826 1.6863 11.7796 22.1018 -16.0737 -10.0998 +11 2 5.81214 2.23354 12.2013 -20.9633 15.3476 12.0772 +12 2 6.02072 0.836228 11.6256 -4.8988 -3.15305 -3.34718 +13 1 6.89097 5.45035 2.38694 -14.0878 18.1315 0.804401 +14 2 6.23022 6.01625 2.92115 27.2653 -21.4077 -23.7527 +15 2 6.91491 5.77412 1.45583 -9.40281 2.39732 25.4334 +16 1 16.2334 10.2315 16.0664 1.22095 -12.8583 -8.35396 +17 2 17.1105 10.2758 15.679 0.521344 2.88453 0.293596 +18 2 15.9464 11.1361 16.1778 -3.48259 10.2735 3.78324 +19 1 10.8573 15.0007 2.35193 -8.17785 -20.274 -7.01899 +20 2 10.8024 14.5151 3.19219 -3.98998 0.859093 -1.88791 +21 2 11.3201 15.8014 2.5578 8.92048 16.4226 10.3474 +22 1 17.1726 8.21805 11.024 14.0848 -19.0512 -23.2094 +23 2 16.691 8.91369 11.4632 -8.36385 12.6057 9.94503 +24 2 17.8921 8.64427 10.518 -5.71892 -0.131476 8.97419 +25 1 14.5956 15.9799 16.3132 20.7515 -13.8502 3.42179 +26 2 13.7469 16.3872 16.1713 -21.6627 3.23661 7.28294 +27 2 14.5521 15.3865 17.0935 -1.40849 8.21009 -3.21798 +28 1 12.1509 13.2395 0.573493 6.57205 3.5904 2.72349 +29 2 11.837 13.3986 18.3303 -3.80405 -1.74926 -15.723 +30 2 11.7012 13.9105 1.09717 -2.12612 0.929616 9.94365 +31 1 9.32377 5.48511 3.80515 37.2224 0.919853 24.8976 +32 2 8.88878 5.295 4.65312 -11.8166 2.00864 -7.28102 +33 2 8.70235 5.44743 3.10202 -35.0307 -2.6733 -15.0358 +34 1 1.53449 3.88906 11.5762 -21.4592 42.8438 -26.3691 +35 2 1.39761 4.77552 11.9865 7.05639 -9.88004 -9.22537 +36 2 1.89707 3.34621 12.2331 21.1403 -27.4328 37.6181 +37 1 2.11621 6.94729 8.0812 -5.52003 -16.2776 -1.04121 +38 2 2.5746 7.45442 8.7366 8.45236 15.6822 11.2536 +39 2 2.08388 6.07661 8.50513 -4.57751 -6.44388 -7.47435 +40 1 5.24695 4.43578 7.8028 -6.30612 26.2857 -2.69952 +41 2 5.36677 3.49844 7.65426 0.215716 -12.5366 -1.65761 +42 2 4.56392 4.76953 7.18377 10.1949 -9.65667 2.91339 +43 1 3.43524 2.88686 17.4376 -21.7675 5.87472 14.6558 +44 2 3.90981 3.17382 16.6701 17.8952 10.4272 -14.0542 +45 2 2.87759 3.6541 17.6984 8.18662 -9.04753 2.1829 +46 1 7.55778 5.57378 6.15352 3.99821 9.40639 19.9011 +47 2 8.12518 6.20749 6.66299 -12.9927 -14.0765 -9.88952 +48 2 6.98227 5.15891 6.82729 7.75312 -1.10557 -10.9113 +49 1 9.77611 7.00478 12.0482 -6.90333 -2.64414 -8.04886 +50 2 10.0224 6.11753 11.7611 0.642082 2.81741 -0.891425 +51 2 9.0843 7.2891 11.4183 2.80801 -0.947675 5.79882 +52 1 14.1423 3.90191 8.16294 -23.6925 4.35767 -24.2753 +53 2 13.5235 4.53411 7.72337 18.2577 -11.8103 7.89417 +54 2 14.4024 4.31063 8.97869 6.95814 7.70003 16.5888 +55 1 4.54437 17.2359 3.8519 4.03565 10.1791 3.31349 +56 2 5.34213 17.7268 4.08304 4.36901 -6.62302 -0.267376 +57 2 4.17051 17.7127 3.09453 -6.96766 -2.87365 4.53203 +58 1 16.1339 16.4921 10.5971 24.4543 -12.0388 -34.7313 +59 2 15.4578 16.6815 11.2098 -23.1752 5.77424 26.3474 +60 2 15.6745 15.9439 9.92709 9.81353 9.26167 7.23238 +61 1 1.98282 4.87023 -0.0102057 11.328 -31.2723 15.691 +62 2 2.56866 5.25094 0.666382 -3.10152 5.14206 -1.69339 +63 2 1.65849 5.5885 18.1127 -8.58794 22.0564 -11.6074 +64 1 11.0975 13.3336 16.4568 21.334 -26.4555 -13.6253 +65 2 10.7319 12.43 16.5661 -7.83355 14.7592 4.38577 +66 2 11.7328 13.1734 15.7328 -3.59268 8.82171 6.12988 +67 1 9.983 10.9188 16.8195 21.8027 -17.9597 14.5818 +68 2 10.5015 10.1139 17.0687 -12.258 16.9146 -11.8156 +69 2 9.08607 10.6082 16.6912 -8.94921 1.38614 -3.26281 +70 1 11.9148 17.5563 13.4787 -11.9158 -12.5975 -1.23623 +71 2 12.5676 17.2101 12.8515 -0.0246338 2.67811 4.16536 +72 2 12.0003 18.5089 13.4756 8.75914 10.3848 -3.31648 +73 1 6.43245 9.54572 12.2957 1.63429 -3.34072 -14.2423 +74 2 7.08046 9.15867 11.6656 -10.0512 7.63496 6.98562 +75 2 6.90317 10.1892 12.8448 2.76093 -9.73394 -7.4892 +76 1 16.2985 12.7819 2.78073 -6.76278 9.02259 -0.251856 +77 2 17.1507 13.1937 2.56739 -3.11425 -2.92719 1.79117 +78 2 15.6658 13.5347 2.78258 7.1706 -12.5209 -0.796151 +79 1 0.705375 12.7757 5.80641 -31.4327 0.785322 -26.0818 +80 2 0.964058 12.7408 4.86595 9.86444 -3.28161 8.94612 +81 2 18.3663 12.6813 5.72517 19.7421 -2.33124 11.5636 +82 1 5.30386 16.3127 18.466 5.80758 -1.43031 -6.37222 +83 2 5.80257 15.6526 17.9366 -5.42534 13.184 13.7491 +84 2 5.92544 16.7092 0.45256 -3.43112 -6.46136 -2.11967 +85 1 0.781035 7.63768 4.09742 11.023 -5.93732 13.9838 +86 2 0.258202 7.96457 3.37539 -14.755 3.95315 -10.1558 +87 2 1.66078 7.97253 3.8829 3.26007 -0.00880383 4.41534 +88 1 3.24417 9.16605 6.56429 -20.4701 -14.3326 2.83801 +89 2 3.57159 8.65908 7.31953 1.49107 7.58135 -6.52778 +90 2 2.30098 8.88971 6.4655 20.5558 12.7829 2.43715 +91 1 7.26627 10.4004 16.2591 -15.7562 -6.32656 27.9079 +92 2 6.82075 11.2368 16.4586 5.73239 -2.42146 -6.93429 +93 2 6.93167 9.82605 16.9811 6.22417 8.86745 -10.8084 +94 1 10.9892 0.849679 5.07849 4.12027 -5.76689 -13.93 +95 2 11.0513 1.64213 4.53259 0.725375 9.02843 9.39609 +96 2 10.6504 0.238952 4.4041 -0.868918 -3.08012 11.6628 +97 1 4.18223 2.98976 13.1617 1.80285 -9.79496 -4.9743 +98 2 4.46754 3.28562 14.0477 -4.0491 -7.36491 -7.89898 +99 2 4.03841 2.01285 13.1683 3.67857 16.3758 11.7633 +100 1 8.4888 10.2856 1.85141 10.3375 -10.6918 -8.28538 +101 2 8.43451 10.9691 2.52904 -3.58901 -0.686288 7.94652 +102 2 8.82874 9.48425 2.29142 -6.1923 10.8646 1.43904 +103 1 10.2336 1.64305 15.4458 -13.2429 9.10796 4.38269 +104 2 11.1732 1.63861 15.572 16.9305 -2.55664 -1.17381 +105 2 10.0536 2.05804 14.5895 6.55462 -3.46994 -1.37038 +106 1 2.58993 12.7242 7.97336 -7.23425 -8.94691 3.8681 +107 2 3.01571 13.5704 7.82234 5.57764 5.06786 -6.45979 +108 2 1.98486 12.5774 7.23174 0.806159 4.05811 0.362671 +109 1 3.90685 11.8307 5.02738 -19.955 -7.05304 -0.3571 +110 2 3.70751 11.1281 5.68153 3.09094 12.242 -8.4391 +111 2 3.06715 12.0092 4.53628 19.8771 -7.15241 7.2697 +112 1 6.7679 14.5791 16.9276 2.77817 -6.983 11.0716 +113 2 7.71708 14.7379 16.9268 0.980214 1.28706 0.809355 +114 2 6.44853 14.8723 16.076 -0.709014 -5.22289 -12.1565 +115 1 14.1752 14.508 3.1348 7.33594 -12.7834 -7.22412 +116 2 13.6105 15.2801 3.10139 -3.55206 9.35654 4.80996 +117 2 13.7682 13.8754 3.73922 -4.33905 3.15851 6.00261 +118 1 8.77346 18.0937 16.1268 -49.3086 -19.2657 7.09896 +119 2 9.29148 17.2891 16.2682 10.0054 9.31596 -1.94744 +120 2 9.22615 0.228463 15.833 27.8858 8.66202 -5.29688 +121 1 4.63977 1.75161 4.89947 12.6555 12.3233 -26.7382 +122 2 3.82082 2.25711 4.97207 0.159842 -3.07614 2.23584 +123 2 5.05477 2.09313 4.05862 -7.26402 -10.6651 28.8422 +124 1 15.0293 12.6717 16.5117 -23.31 -0.861404 35.6256 +125 2 14.4426 12.7177 17.3057 24.815 2.28331 -11.4604 +126 2 14.393 12.496 15.8301 -9.60755 -0.359254 -28.8722 +127 1 15.7282 18.4115 16.8424 17.2085 30.6847 -2.58542 +128 2 16.585 18.5255 17.3163 -17.0651 -10.3906 -2.34083 +129 2 15.5073 17.4884 16.7844 1.64687 -19.4864 2.05956 +130 1 1.3653 1.32145 16.674 4.57571 12.7751 22.4809 +131 2 2.22966 1.72757 16.8986 -13.3853 -7.67206 -8.47788 +132 2 0.843747 1.53379 17.4789 2.23908 -6.3926 -16.4011 +133 1 18.2502 4.28823 15.9426 5.59379 -7.24598 -18.3859 +134 2 17.8025 3.49471 15.6029 3.53909 11.4984 4.55434 +135 2 0.380345 4.42598 15.3659 -10.3938 -1.91133 11.4 +136 1 12.0179 17.0993 16.1449 -24.7595 -29.8482 27.6473 +137 2 11.2904 16.5264 16.5371 30.7476 29.6052 -3.96723 +138 2 11.7854 17.0696 15.2267 4.30162 8.23296 -25.5613 +139 1 16.0455 2.77586 18.2041 10.6955 -6.31261 -1.53201 +140 2 15.9135 3.65525 18.5895 -10.0784 -5.09061 -10.2232 +141 2 15.7148 2.7749 17.2908 -2.70848 4.2718 2.75475 +142 1 6.57887 13.7167 10.0128 0.388305 24.4332 24.1101 +143 2 6.2636 13.3347 10.8463 6.37938 -3.40375 -0.55213 +144 2 6.43171 13.0818 9.3305 3.17506 -19.669 -12.997 +145 1 10.1062 18.565 2.71626 12.0596 2.32822 -17.6158 +146 2 10.7563 0.294125 2.0815 -9.9929 -7.47975 8.60443 +147 2 9.2984 18.4331 2.20633 -1.12272 -0.999648 5.59115 +148 1 3.10044 17.6571 6.21769 -0.590198 -1.20238 18.0356 +149 2 2.16339 17.7471 5.9649 14.558 -0.242179 -11.811 +150 2 3.6505 17.6877 5.42436 -8.00238 0.252249 -9.63341 +151 1 12.5899 16.7797 7.85568 11.434 -9.28582 -14.859 +152 2 11.8995 16.1049 7.73478 -4.76829 8.38316 1.604 +153 2 12.3367 17.3735 8.55676 -7.89443 8.69289 16.0625 +154 1 14.8958 15.3252 8.42405 -10.9907 16.0866 -10.412 +155 2 14.2257 15.9607 8.05927 9.60746 -16.915 15.6813 +156 2 15.568 15.2992 7.73812 1.83068 -0.846784 -8.90808 +157 1 17.9236 18.2959 0.16927 -20.6229 -20.5305 -14.2597 +158 2 18.7101 17.7336 18.8116 8.98564 4.8691 -3.01699 +159 2 18.0908 0.428516 0.675884 12.0916 17.8267 11.1415 +160 1 0.800533 10.4853 1.48213 -15.9305 -52.1134 32.1201 +161 2 0.0210499 9.87138 1.72712 35.348 27.3948 -12.4938 +162 2 0.488783 11.092 0.839839 -12.4886 25.7711 -24.5144 +163 1 1.85398 12.3107 3.26054 -2.39029 3.71051 2.5874 +164 2 1.61156 11.5651 2.68837 -2.80207 3.45241 0.205878 +165 2 2.01622 13.0664 2.66785 -2.08994 -5.59574 4.32216 +166 1 0.726068 17.2941 4.97534 23.1964 8.93599 -27.6283 +167 2 -0.00504426 17.9045 4.96895 -11.3657 3.83105 9.40925 +168 2 0.6848 16.6356 5.64734 -16.8394 -17.6158 22.5419 +169 1 0.979774 0.931094 9.39103 18.34 6.67236 9.68687 +170 2 1.13606 0.587208 10.3041 -6.25966 0.627701 -15.4141 +171 2 0.222638 0.493139 9.00427 -6.20505 -6.29115 6.11619 +172 1 16.8132 2.44689 13.4524 12.1018 18.2567 -5.29927 +173 2 16.9941 2.74318 12.5312 -5.60486 -9.11594 12.8952 +174 2 16.5475 1.52939 13.4414 -4.39811 -15.2301 -8.28386 +175 1 2.68823 16.0572 12.0971 4.35106 -7.5731 1.60029 +176 2 3.00862 15.6347 12.9147 -3.00711 3.68751 -12.4652 +177 2 3.25289 15.7623 11.3532 -3.53001 -2.50035 7.7005 +178 1 16.365 15.3972 6.07793 1.10786 -2.726 6.22736 +179 2 17.2616 15.5854 6.39959 0.338369 -3.43469 -2.74975 +180 2 16.1217 16.1306 5.49548 2.77772 2.55878 -2.13745 +181 1 5.71885 5.23685 11.7571 -1.38587 -22.0348 -7.59079 +182 2 5.34065 5.94353 12.2818 1.95161 11.9795 4.35233 +183 2 5.13977 4.47517 11.9216 1.17844 4.76848 -1.31072 +184 1 15.1029 4.9502 0.771222 1.99697 3.13949 16.3358 +185 2 15.0181 4.74755 1.72068 1.03511 -0.706475 -1.64751 +186 2 14.2572 5.32925 0.539529 -7.17443 2.24029 -6.36177 +187 1 16.4241 16.5209 1.77175 11.7834 22.2537 -31.9797 +188 2 16.1353 16.901 2.59837 -3.82757 4.70614 16.3909 +189 2 16.7243 17.3043 1.2165 -7.10171 -29.7856 17.5505 +190 1 0.166785 4.90105 4.02875 -9.807 6.14851 -6.2016 +191 2 0.490919 5.80972 4.19933 1.47178 -10.2493 -2.87817 +192 2 0.85797 4.25703 4.16889 13.481 4.94217 6.1798 +193 1 2.95388 15.1092 15.162 10.7369 -8.35154 -8.83455 +194 2 2.79081 14.8128 16.074 0.0767364 3.70074 1.09557 +195 2 2.55949 15.9866 15.0864 -8.26758 5.41964 7.36053 +196 1 1.08589 14.7081 9.5149 24.8711 -1.95174 9.92838 +197 2 2.02655 14.926 9.73253 -22.6422 -7.57261 -8.5802 +198 2 0.981604 13.769 9.74603 1.17561 7.47496 0.770389 +199 1 13.5787 16.5188 11.5692 -12.2314 13.2219 -8.78769 +200 2 13.3397 17.246 10.9551 -0.181138 -8.24863 9.65793 +201 2 12.9892 15.7954 11.3146 2.83531 -7.80051 -5.41791 +202 1 4.81777 1.55092 0.678258 -26.6156 -3.92273 4.29753 +203 2 4.35705 2.21925 0.160828 3.99581 1.83661 -5.90848 +204 2 4.05187 1.04139 1.04246 22.8613 -3.7169 0.169547 +205 1 1.54475 18.6679 11.892 -7.41525 16.2224 7.56704 +206 2 1.47416 0.586534 12.6867 1.33096 -5.97454 -6.01551 +207 2 1.79005 17.7987 12.209 7.72027 -7.46968 0.191542 +208 1 11.4358 10.1471 4.23265 -10.894 -3.87129 -8.35951 +209 2 11.2613 10.4034 3.31126 9.28636 4.56211 3.82985 +210 2 12.3915 10.0236 4.32197 -4.85978 3.43988 -0.432274 +211 1 8.20336 12.1359 3.88849 -13.0458 16.1374 35.7669 +212 2 8.99874 12.5954 4.16275 16.0075 -1.33649 -14.8839 +213 2 7.69556 12.2697 4.73273 -2.96338 -15.3566 -29.2591 +214 1 14.5957 4.06338 3.37559 11.9385 -4.24509 -11.5663 +215 2 15.1907 4.01381 4.14053 1.35901 4.80596 -1.61984 +216 2 13.7786 4.41816 3.71066 -15.4173 6.10577 6.17301 +217 1 5.71905 1.6749 7.61995 8.80947 6.26404 67.7498 +218 2 5.099 1.08549 8.07836 1.13728 7.44943 0.131268 +219 2 5.55556 1.51371 6.73852 -13.1925 -8.9768 -74.4163 +220 1 17.8986 1.04478 4.82737 2.1754 -1.83476 -0.744307 +221 2 18.4917 1.14925 4.06283 -1.19754 2.46044 8.41233 +222 2 18.3052 1.49477 5.5864 -1.29774 -0.0865267 -3.68542 +223 1 6.84138 9.15652 4.5536 4.1666 1.31036 -3.45285 +224 2 6.90548 9.53593 5.43168 -5.85674 1.32054 6.56912 +225 2 7.76285 8.95875 4.34348 -1.51129 -0.833856 -3.18299 +226 1 2.51554 14.7147 2.08788 -0.0450507 -1.43316 -6.26715 +227 2 3.18184 14.7861 2.78103 3.7873 -1.55841 0.251503 +228 2 3.00277 14.5163 1.27395 -5.30581 6.45149 3.77223 +229 1 17.2192 13.0031 13.0554 -12.0926 -3.19634 4.57291 +230 2 16.3553 13.3969 13.3572 27.3304 0.34804 -8.60607 +231 2 17.7786 13.6982 12.6582 -16.3476 4.90844 7.68697 +232 1 14.8182 10.5634 1.61386 4.26778 13.3748 6.0388 +233 2 15.4677 11.1895 1.9919 -6.32062 -5.48184 -5.48699 +234 2 13.979 11.0422 1.62876 3.88819 -6.35193 -1.63244 +235 1 5.61579 6.74404 4.50101 -16.4591 -25.6922 -2.42498 +236 2 5.98931 7.61359 4.54862 8.72135 21.7956 -0.434523 +237 2 6.18395 6.1944 5.05334 5.89398 3.69136 0.98365 +238 1 7.99723 8.25195 10.2692 14.8304 8.84149 10.0706 +239 2 8.65992 8.88256 9.91656 -9.90097 -8.80766 -1.78449 +240 2 7.59566 7.7759 9.52484 -1.48617 9.19501 4.49734 +241 1 13.4628 18.4324 5.71378 17.6235 1.75148 -9.47684 +242 2 12.708 0.350866 5.56458 -19.7852 7.87128 -2.36248 +243 2 13.2811 17.9777 6.53219 -7.30606 -12.1428 7.93723 +244 1 0.0668655 2.55772 0.44163 -1.64079 -15.5797 1.12414 +245 2 17.7792 2.62308 0.158326 7.01821 10.3157 -4.2768 +246 2 0.560589 3.37114 0.261458 -5.35649 7.7487 -2.70304 +247 1 12.8473 10.8167 9.6749 -29.1069 48.3462 -20.1155 +248 2 11.856 10.995 9.62541 32.1605 -20.6147 5.13184 +249 2 13.0142 9.92242 9.94244 -8.5776 -22.9331 5.75343 +250 1 0.607197 12.3488 11.1216 10.7177 -2.21067 3.69277 +251 2 18.3016 12.4338 11.1296 -15.0263 -0.672926 -5.71109 +252 2 0.887353 12.7089 11.9725 7.71276 -2.01358 -2.19338 +253 1 5.32001 7.36668 13.2938 5.32433 15.1635 7.63099 +254 2 5.70557 8.20602 12.9842 -2.91102 -7.98825 -6.07053 +255 2 5.82609 7.21997 14.1065 -9.96591 -5.08448 1.55341 +256 1 1.1733 6.74916 11.943 -30.749 -23.7015 -12.6924 +257 2 0.265139 7.01822 11.7017 14.0517 -0.957096 2.97943 +258 2 1.61086 7.53614 12.2133 15.6557 23.6476 13.031 +259 1 15.5486 9.75906 12.4999 -0.653644 29.4777 3.96245 +260 2 15.1521 10.5891 12.1135 7.41979 -25.1975 16.8694 +261 2 15.9641 10.0301 13.3422 -9.48671 -5.05259 -12.6364 +262 1 16.5044 12.5382 5.51299 -3.50049 1.7151 -41.7779 +263 2 16.2902 13.4721 5.54585 0.30498 11.7411 21.1442 +264 2 16.3754 12.4207 4.53497 7.77761 -11.637 24.1999 +265 1 6.32544 9.92844 0.21289 -23.4091 -5.64021 -11.1485 +266 2 5.58447 10.3552 0.689761 9.59747 -6.57127 -5.34636 +267 2 7.10511 10.1371 0.71679 14.7949 3.34633 14.2781 +268 1 12.1134 5.97718 4.01208 -22.8865 -14.7559 9.656 +269 2 12.2541 6.73773 3.46345 4.76282 13.7738 -16.8186 +270 2 11.1454 5.80116 3.92348 22.2207 -1.187 3.16864 +271 1 0.310021 12.9061 0.00438974 -4.95288 1.79463 -7.14095 +272 2 18.578 13.473 0.695812 6.768 -1.51286 0.947724 +273 2 18.4929 13.1888 17.8371 0.864006 -6.25549 9.7975 +274 1 3.57649 0.0893425 8.67318 10.7138 1.44606 -23.5182 +275 2 3.53585 18.3471 7.78602 0.204258 -6.73647 -0.0210952 +276 2 2.75019 0.556646 8.71194 -17.5671 6.50862 13.0872 +277 1 7.32229 17.553 4.46711 -1.8346 22.7033 -6.51397 +278 2 7.49747 18.5341 4.60164 1.92735 -36.6431 -12.1684 +279 2 7.43093 17.3591 3.50845 0.44318 8.65947 16.4016 +280 1 9.23372 17.1692 12.2368 -1.40541 18.7929 10.7586 +281 2 9.17923 16.5713 11.4947 6.54031 -16.824 -6.24154 +282 2 10.1445 17.1937 12.5849 -6.50468 -4.83213 -2.69749 +283 1 13.3883 13.1392 7.89062 -8.44361 -29.718 12.0449 +284 2 13.2983 12.3346 8.48336 5.26587 25.8846 -16.8323 +285 2 14.1176 13.673 8.22732 -1.02664 3.48474 5.19869 +286 1 14.8313 2.83639 15.4549 13.5448 -0.0778016 6.35676 +287 2 14.1767 2.18003 15.2177 -4.87233 -8.03631 -4.89691 +288 2 15.4971 2.82305 14.7488 -5.52573 3.83225 -1.21536 +289 1 9.88985 15.6498 16.9162 -1.5178 12.6863 -12.8881 +290 2 10.4068 14.8878 16.6522 -4.3383 -15.6303 0.424585 +291 2 9.57752 15.4658 17.7984 -6.29913 -5.39682 13.2163 +292 1 11.1832 8.45041 16.604 0.69795 7.62392 -5.91094 +293 2 10.4558 7.91494 16.2714 -2.08228 -2.22425 -3.83894 +294 2 11.7364 7.86183 17.1086 3.16052 -9.92137 8.33691 +295 1 3.98058 18.2281 16.8796 4.69725 -6.17709 8.80305 +296 2 4.47544 17.5796 17.4031 -3.04366 -6.21568 -3.2578 +297 2 4.2975 0.415113 17.2284 -3.71051 8.24157 -1.82763 +298 1 2.31186 4.29334 8.90298 15.9673 -19.5394 32.2139 +299 2 3.25638 4.01729 8.88792 -18.4415 10.5974 -6.3491 +300 2 2.00846 3.99585 9.80326 5.50039 13.6474 -24.2252 +301 1 9.93626 10.4071 9.85717 -7.16433 6.26663 -15.7674 +302 2 9.36967 11.1624 9.60099 8.89086 -7.49456 6.1891 +303 2 10.0442 10.3828 10.8072 -0.648607 3.91668 13.0823 +304 1 9.8312 0.910661 10.8223 11.6198 7.73817 -5.63486 +305 2 9.46664 0.0599513 11.0613 -12.5627 -8.03565 7.40448 +306 2 9.23233 1.33675 10.1908 -3.5905 -1.89286 -1.84539 +307 1 9.13587 15.2239 10.1542 8.27875 -9.17261 13.8125 +308 2 8.75897 15.8188 9.50902 -6.94043 7.83547 -6.48358 +309 2 8.46187 14.5466 10.3059 -2.40816 2.69742 -4.7236 +310 1 0.685213 9.67274 10.114 -7.63752 22.5158 18.5003 +311 2 0.719625 10.5209 10.6443 4.69174 -21.4783 -21.4849 +312 2 1.56632 9.47392 9.79675 4.15873 2.44002 -0.184199 +313 1 17.1428 4.74332 7.9842 -7.49261 0.0436566 15.7002 +314 2 16.4923 5.43036 8.24486 9.33931 -9.59151 -5.74994 +315 2 17.1543 4.09081 8.70481 -1.62938 8.73821 -5.69634 +316 1 14.873 14.5838 0.184633 -12.5055 -0.863041 8.47648 +317 2 15.4452 15.0773 0.785336 2.49238 5.2379 -3.7088 +318 2 14.1221 14.3325 0.749692 6.56524 -1.80757 -8.31994 +319 1 3.93739 11.0893 9.63941 -1.02455 -14.3236 -20.6383 +320 2 3.83455 11.1931 10.5803 -4.40039 8.60569 15.1914 +321 2 3.22961 11.5882 9.19534 2.92088 3.20496 1.27781 +322 1 11.4787 10.7372 1.42758 24.3197 -0.772389 9.7934 +323 2 11.803 11.5915 1.09275 -4.97826 -3.71445 3.9898 +324 2 10.5984 10.6629 1.1011 -26.1902 -1.18673 -8.43185 +325 1 13.1873 7.21634 12.6041 -15.1781 -16.7535 7.59792 +326 2 14.1321 7.04558 12.6338 7.66113 -4.04391 -1.22332 +327 2 12.7625 6.33802 12.7657 6.99529 16.5731 -3.03327 +328 1 9.70202 2.01155 0.798053 14.7354 3.6785 18.4689 +329 2 8.80874 1.78739 0.563168 -12.7542 -2.84597 -8.5823 +330 2 10.1462 2.35336 0.0231027 2.1886 1.53799 -6.67264 +331 1 10.5601 13.4177 4.61479 15.5689 5.45852 21.4774 +332 2 11.4398 12.9929 4.68798 -8.71776 0.745444 -2.53542 +333 2 10.4627 13.8549 5.48714 -1.1208 -2.16649 -13.1077 +334 1 14.6135 1.64587 10.9888 -15.9483 2.47769 1.03658 +335 2 15.3653 1.14828 10.6398 3.3395 9.35485 -7.37665 +336 2 14.6055 2.55489 10.6162 9.33106 -12.1869 7.67578 +337 1 14.4205 12.072 11.5247 -14.0438 -11.3661 -21.2086 +338 2 15.2325 12.1783 11.0185 5.83651 11.9615 0.736203 +339 2 13.7775 11.7491 10.8405 12.2041 8.47933 23.407 +340 1 8.16075 5.17074 9.91542 -32.2508 22.4833 15.2463 +341 2 7.26447 5.43351 10.2769 29.6925 -9.34554 -9.10024 +342 2 8.08912 4.23235 9.75273 2.68018 -15.2376 -3.85437 +343 1 1.73754 17.0197 18.4251 17.7604 24.8388 -20.6387 +344 2 2.31535 17.5448 17.7835 -20.2636 -19.608 22.2942 +345 2 1.91865 16.0976 18.2314 3.71033 -9.13614 -1.37747 +346 1 1.38218 17.4352 15.3141 25.6123 -1.10879 -8.05345 +347 2 1.40837 18.2867 15.7687 -7.1514 0.273564 3.63966 +348 2 0.483975 17.1212 15.2601 -14.2857 -2.70278 3.05549 +349 1 3.46713 5.71669 6.03858 -5.21329 -0.208659 9.269 +350 2 3.09179 6.35885 6.66621 -4.29108 -6.04245 -5.71481 +351 2 3.94628 6.22951 5.39233 13.1871 8.33197 -8.25473 +352 1 12.7108 9.52885 14.2713 4.43437 -19.6411 -8.16456 +353 2 13.1132 8.73466 13.871 -3.04318 14.9787 -8.97539 +354 2 12.4252 9.15135 15.1011 -11.0135 5.38653 13.5706 +355 1 4.12803 15.1962 7.19495 12.4066 -8.66704 -3.75127 +356 2 3.59847 15.8823 6.77325 5.03517 9.17322 -2.57748 +357 2 5.08076 15.3227 6.96437 -18.0652 5.77836 0.725546 +358 1 0.842345 8.89099 15.1297 2.31502 -25.1166 0.479797 +359 2 0.506769 9.78853 15.0967 4.66165 8.13805 -4.97691 +360 2 1.56169 8.8202 14.4757 -4.5077 5.49756 1.76436 +361 1 12.9722 8.22706 10.1223 30.4908 -35.0116 2.62512 +362 2 13.7358 7.69898 9.75664 -18.6412 19.8455 -0.140907 +363 2 12.9154 7.83668 11.013 -6.3959 11.2287 -1.2259 +364 1 15.209 8.0796 3.38747 1.18456 -35.8933 6.76248 +365 2 14.5518 7.57266 2.91157 -10.3511 16.9608 -18.4151 +366 2 15.3784 7.42989 4.0872 14.9983 19.582 11.3682 +367 1 17.1108 6.70081 18.626 -14.4882 23.5427 -0.564853 +368 2 16.573 5.93167 0.182006 3.19594 -3.93797 2.70551 +369 2 16.4292 7.40436 18.4932 17.3888 -11.7094 -2.73385 +370 1 8.93374 7.05508 7.97597 -34.6157 -22.4872 9.48373 +371 2 9.83531 7.32727 7.97774 29.5921 7.62374 2.22252 +372 2 8.80811 6.41093 8.72029 6.54491 10.6746 -16.3243 +373 1 12.5312 0.423333 1.1911 6.44852 -9.8202 9.01884 +374 2 13.2753 0.834119 1.64897 1.63592 5.99122 -1.78887 +375 2 12.9315 0.0607692 0.396252 -6.77848 2.89528 -3.69601 +376 1 5.75537 14.98 14.4363 12.3645 2.0371 -4.21343 +377 2 4.82148 15.0687 14.6213 -16.3449 4.01416 5.01671 +378 2 6.0882 15.8478 14.162 -3.83146 3.10822 0.706071 +379 1 3.69037 6.49544 1.72037 -3.07239 6.81288 -7.41536 +380 2 3.43088 7.36249 1.36332 1.27628 -12.1507 -2.18765 +381 2 3.67848 6.67228 2.6574 4.23334 -3.71069 10.2966 +382 1 3.82256 11.2843 12.3046 -0.864415 -4.77059 0.0245619 +383 2 4.71622 11.5939 12.5181 -0.579536 5.4381 2.57712 +384 2 3.18979 11.9063 12.6819 -0.230908 7.2683 5.57723 +385 1 5.33149 3.8717 15.6726 -21.611 69.2317 6.1195 +386 2 6.02506 3.28248 15.4947 35.9646 -33.3333 -4.61122 +387 2 5.75271 4.79171 15.6869 -18.1046 -35.0984 -1.75377 +388 1 13.9893 10.0773 4.7789 22.4286 4.91544 -48.853 +389 2 14.2819 9.66907 5.58109 5.23319 -9.97863 19.9681 +390 2 14.5573 9.69868 4.0468 -17.0356 6.64649 24.2901 +391 1 7.62039 17.28 9.03644 -1.79817 -13.3385 2.54351 +392 2 6.82618 17.452 9.57294 2.68689 7.94648 -2.92213 +393 2 7.87136 18.0666 8.53956 -0.560867 8.99315 -4.02364 +394 1 4.58082 14.4709 3.89205 3.13293 1.46958 -13.0867 +395 2 4.66344 15.3386 4.31009 -0.0981131 -0.860678 2.59791 +396 2 4.56838 13.761 4.54421 -0.137719 -0.424919 8.72805 +397 1 14.11 7.4138 15.8858 20.156 9.8447 -1.08692 +398 2 14.9007 7.50898 15.3123 -12.2349 -4.78906 9.9244 +399 2 14.35 7.89712 16.7003 -4.15301 -9.39138 -6.29924 +400 1 2.88871 18.3931 1.90601 -10.0733 25.2579 5.70796 +401 2 2.56074 17.6209 1.45485 -4.97176 -8.65563 -11.6917 +402 2 2.08224 0.29716 2.10455 27.8478 -15.7521 2.2348 +403 1 8.03506 1.57584 4.43091 11.32 6.26446 5.75526 +404 2 7.34029 2.01323 3.92479 3.96785 0.109851 -4.32136 +405 2 8.88243 1.87946 4.04557 -12.5027 -7.48646 4.71123 +406 1 2.59748 14.2159 17.7933 -41.9258 1.66076 -8.0641 +407 2 1.85609 13.5734 17.9588 19.2075 16.8599 2.55802 +408 2 3.39352 13.7425 17.9784 23.6145 -16.2032 6.42715 +409 1 1.02442 1.99672 13.9281 17.4639 2.95853 -13.5386 +410 2 1.00308 1.87917 14.8709 4.63864 -6.80727 18.6653 +411 2 18.7659 2.1043 13.6716 -21.6962 3.88026 -3.66909 +412 1 4.27686 0.20187 13.9044 10.5162 4.04171 -16.044 +413 2 5.10447 18.3372 13.9403 -4.05013 6.4475 2.1433 +414 2 3.72354 18.5099 14.5979 -6.57077 -5.71295 14.511 +415 1 7.38305 1.01959 18.4815 -37.4449 7.12948 8.58409 +416 2 7.61008 0.74545 17.6036 5.58611 -6.30497 -21.5445 +417 2 6.41018 1.26146 18.4662 31.347 -10.6343 7.25927 +418 1 15.7518 18.4403 13.8831 -5.31168 6.41878 -7.08883 +419 2 14.7988 18.525 13.6912 13.3949 -2.54728 9.28792 +420 2 15.9153 18.5927 14.8217 -8.96218 -2.42265 4.9219 +421 1 10.3004 4.59906 16.2125 -26.9192 -42.5531 9.44494 +422 2 11.2318 4.75068 16.1287 26.1471 2.80018 1.93501 +423 2 10.2211 3.60629 16.3773 -0.864587 37.9812 -10.9337 +424 1 15.8848 17.7109 4.47524 -26.0192 -17.7161 -6.69824 +425 2 16.416 18.4558 4.72522 12.9982 18.1701 2.23702 +426 2 14.9575 17.9834 4.62838 14.848 -2.41832 2.25768 +427 1 6.86545 17.6577 14.0262 -6.12412 -8.41921 6.45462 +428 2 7.47866 17.6693 14.7646 2.09746 6.93436 13.8689 +429 2 7.44902 17.4838 13.2997 11.4214 -0.145135 -19.8537 +430 1 13.1703 6.41318 6.52816 -11.7529 -0.316938 -15.1514 +431 2 13.9829 6.90375 6.37155 7.88734 -3.14145 2.99861 +432 2 12.7537 6.33512 5.64174 6.34445 -4.78434 12.9923 +433 1 7.85335 2.30114 9.49646 -14.1039 1.33546 -28.6309 +434 2 7.23443 2.06415 10.1901 -3.07143 2.26257 12.1486 +435 2 7.33833 2.15664 8.66054 15.7097 0.546065 18.7565 +436 1 15.1664 14.7315 13.8676 -13.4222 3.7476 -0.777794 +437 2 14.8716 15.1233 14.7167 4.70885 -6.20173 -11.3706 +438 2 14.4912 14.9291 13.1959 7.90291 2.0321 9.20294 +439 1 9.36434 8.4507 3.85153 -5.45323 -8.44175 -9.3174 +440 2 10.195 8.80526 4.18009 6.07261 4.07641 1.89943 +441 2 9.48655 7.50041 3.73575 1.17631 -1.18483 4.07146 +442 1 17.585 13.5529 16.4533 28.0827 9.29223 -15.0932 +443 2 16.6463 13.3857 16.5308 -13.0105 5.34146 -4.98563 +444 2 17.7372 14.3421 15.8749 -12.9185 -11.1551 11.5131 +445 1 5.00344 10.4544 2.83444 15.3623 2.39709 8.30796 +446 2 5.84337 10.0047 3.04968 -12.8086 4.14038 -0.288119 +447 2 4.84487 11.029 3.60723 -3.54173 -2.25206 -8.41364 +448 1 3.64071 8.37653 9.83285 -3.63557 -2.42467 19.3481 +449 2 3.86873 9.30617 9.70655 -0.364806 7.27712 -2.43853 +450 2 3.42279 8.30417 10.789 5.82381 -0.771913 -15.5307 +451 1 16.012 6.92262 5.85834 3.10414 -0.205141 -1.95775 +452 2 16.7064 7.38617 6.35888 -2.44937 -6.94247 -7.87698 +453 2 16.3342 6.01666 5.66219 -6.01431 14.0457 5.91674 +454 1 15.3573 7.28861 8.91428 -7.73552 23.9623 -29.5509 +455 2 15.9286 7.60908 9.59449 17.6585 1.69923 20.6432 +456 2 15.3281 8.05346 8.27817 -7.4668 -29.0722 12.6462 +457 1 6.23444 12.7891 12.7562 -16.1216 7.07791 -6.67583 +458 2 7.04381 12.3675 13.028 12.7717 -9.63916 7.37694 +459 2 6.08648 13.5082 13.3891 2.20208 -1.21591 -2.77254 +460 1 12.1275 4.60499 13.1618 30.5736 27.4894 8.79026 +461 2 12.1815 4.60813 14.1323 1.45244 -2.14521 -6.91324 +462 2 11.4269 4.052 12.8891 -30.6572 -22.7655 -2.33684 +463 1 11.4418 8.05897 7.8749 4.39649 -6.11408 4.26725 +464 2 12.0054 7.38105 7.40707 -4.89778 19.9996 19.2901 +465 2 11.7913 8.23063 8.79017 -1.61454 -12.0828 -25.9053 +466 1 16.8934 10.7552 7.64898 5.958 -15.487 6.46706 +467 2 17.5218 10.034 7.45777 0.434714 4.65833 3.39608 +468 2 16.8005 11.223 6.82193 -0.787623 15.1873 -12.5781 +469 1 5.19162 18.0101 10.6182 -11.7475 -9.51575 -5.50364 +470 2 4.6689 17.2843 11.0141 12.267 13.7571 -4.22389 +471 2 4.61649 18.3258 9.88348 13.0529 -7.1725 20.3587 +472 1 7.61953 17.4141 1.49962 -5.28373 3.7131 11.8258 +473 2 8.17503 16.7132 1.19553 7.57367 -21.9054 -5.9523 +474 2 7.57614 18.0024 0.755384 -3.403 20.0604 -6.05803 +475 1 1.93154 12.9424 13.6297 4.26026 1.62766 0.165619 +476 2 1.31807 12.4855 14.2164 3.08324 -4.19991 0.575461 +477 2 2.34989 13.6289 14.1741 -4.48691 2.36366 -2.57882 +478 1 9.34851 6.7636 14.8211 -2.90069 2.43692 -15.7898 +479 2 9.659 5.88476 15.1078 3.08688 5.56829 -7.87962 +480 2 9.50722 6.89182 13.8456 0.484936 -6.74561 22.7152 +481 1 15.2631 4.37275 10.7209 -0.391742 -1.67154 5.71992 +482 2 16.1506 4.03655 10.897 1.37527 -0.677682 -8.66997 +483 2 15.1154 4.97006 11.4686 -2.24536 -2.27818 -6.11794 +484 1 11.4934 6.22632 -0.0241442 -6.06296 -11.7718 -8.66306 +485 2 11.6483 5.30933 -0.309107 4.27028 6.28431 2.83608 +486 2 10.5284 6.3165 18.5406 6.28072 6.83613 2.73886 +487 1 18.4725 11.4275 14.8977 -1.36673 1.10287 -33.3787 +488 2 18.0559 11.937 14.1605 1.63397 -11.827 9.6186 +489 2 18.3384 12.0011 15.6307 -5.5196 20.2825 24.8766 +490 1 7.17852 9.29091 7.31266 -12.1778 -5.70725 -5.55247 +491 2 6.76293 8.42612 7.50122 5.49043 12.248 4.67896 +492 2 8.1168 9.11866 7.26453 10.5183 -1.31775 0.108346 +493 1 18.3399 15.3762 12.1294 6.77425 7.85663 0.444206 +494 2 0.624383 15.5788 11.9067 -6.5428 -1.83873 1.38378 +495 2 17.7957 15.9125 11.5264 -1.63248 -5.99386 0.103645 +496 1 16.5386 4.34911 5.2503 -38.2238 -21.0357 51.9327 +497 2 16.6701 3.96728 6.16388 -6.69454 12.6485 -26.055 +498 2 17.3775 4.32019 4.85382 41.1543 5.3392 -22.1831 +499 1 17.7341 3.08223 10.7755 -2.39486 19.3144 10.8573 +500 2 18.6554 3.32717 10.9901 -9.67157 -6.39923 -2.68969 +501 2 17.7406 2.18791 10.4534 3.10102 -17.6187 -9.33289 +502 1 12.3347 18.6584 10.1394 22.1152 -18.6094 -11.1242 +503 2 11.4269 0.285024 10.28 -5.50333 15.1479 5.74269 +504 2 12.9381 0.769801 10.2484 -7.53185 0.18177 2.36971 +505 1 10.4414 9.72052 12.5804 5.49259 18.5488 2.65475 +506 2 11.2372 9.86145 13.1232 -3.33328 -5.81976 -2.33485 +507 2 10.4983 8.8205 12.2639 -0.9125 -13.8337 3.2089 +508 1 0.576047 2.60181 7.2501 -1.65995 13.3288 -12.3458 +509 2 0.268028 3.48996 7.49944 2.28387 -7.91724 -1.96879 +510 2 1.05133 2.26453 8.01425 -2.57801 -1.32252 3.73717 +511 1 0.35756 15.2681 6.96461 -6.18578 -18.242 -64.2832 +512 2 0.656709 14.9904 7.8095 9.46814 -3.47663 35.1726 +513 2 0.533918 14.474 6.37104 -3.56161 26.9089 25.8891 +514 1 17.0554 6.8805 14.912 24.4713 -1.83906 11.5387 +515 2 17.8121 7.50971 14.9246 -13.4777 -6.95308 -2.51376 +516 2 17.3666 6.12061 15.452 -8.01529 8.59931 -8.57008 +517 1 9.11821 12.4896 7.9597 -39.3936 14.7629 -4.46817 +518 2 9.45619 11.6923 7.5591 7.68398 -14.1787 -12.8233 +519 2 8.20522 12.6235 7.56541 34.2702 -5.52337 13.9854 +520 1 1.14934 1.62531 2.7512 -10.6975 -16.4856 11.3042 +521 2 0.557887 1.95566 2.07466 1.95024 15.5996 -8.59751 +522 2 1.5216 2.35039 3.25303 6.14281 9.13632 1.51194 +523 1 4.18801 15.1235 9.83797 -4.3571 13.9944 -8.49019 +524 2 4.15169 15.4364 8.91421 -7.63033 -5.74015 13.5827 +525 2 5.04261 14.6826 9.83518 3.69587 -3.91806 9.7151 +526 1 7.38616 2.29059 14.8987 -4.38475 3.80451 -15.2317 +527 2 7.23636 1.51405 14.3418 -1.55041 0.530275 6.25745 +528 2 7.45512 3.02747 14.2682 8.09838 -6.66607 2.4433 +529 1 18.2954 14.5248 2.13868 21.7335 16.5649 1.154 +530 2 0.530315 14.9412 2.32201 -13.6123 -15.8317 -3.76049 +531 2 17.7186 15.2797 1.96871 -6.10103 1.83177 1.59348 +532 1 10.0818 2.68123 12.8993 0.213282 -13.011 -16.4533 +533 2 9.9804 2.00538 12.1749 2.58274 17.6757 17.7308 +534 2 9.30115 3.24961 12.8455 -1.77409 -0.0668197 -1.90377 +535 1 2.92042 8.79199 13.1038 3.60331 12.5418 -6.85933 +536 2 3.19747 9.71233 12.8787 -2.51528 -19.5049 2.84802 +537 2 3.74925 8.3139 13.2755 -6.12566 -1.47569 1.35688 +538 1 3.2826 8.6043 3.78787 -1.06696 -30.5523 53.3514 +539 2 3.6648 9.24286 3.23576 21.5217 31.7748 -30.2126 +540 2 3.73659 8.75462 4.6619 -18.3855 -4.45548 -24.3241 +541 1 5.99503 7.23605 8.68049 -5.70462 -6.01689 -7.52618 +542 2 5.88732 6.32464 8.37432 -5.09887 -1.13221 5.21957 +543 2 5.15444 7.50455 9.08765 4.58913 -3.02319 1.70333 +544 1 14.8694 1.67632 1.824 4.95495 -3.07302 -21.4612 +545 2 14.923 2.54765 2.20438 -6.9063 6.82762 18.8127 +546 2 15.1986 1.83723 0.92353 -1.55356 -7.84532 7.79991 +547 1 8.71318 14.9586 0.633889 5.3189 4.72704 12.5337 +548 2 9.41548 15.0137 1.3229 -12.9747 -8.59069 -7.21106 +549 2 7.9574 14.4505 1.00218 9.17218 5.81258 0.251254 +550 1 15.3522 1.50057 7.22863 -1.61242 -14.2743 -3.26221 +551 2 14.7819 0.961058 6.63945 7.54361 11.5891 10.8038 +552 2 14.804 2.18796 7.6304 -1.95204 4.928 -5.75504 +553 1 4.88832 12.8638 18.4669 14.1773 6.076 10.5021 +554 2 5.16486 12.9634 0.754115 -2.57074 -3.9589 -10.7447 +555 2 5.64539 13.2163 17.9734 -6.87045 1.01425 -0.872896 +556 1 15.3658 8.71105 18.1022 0.313753 1.99863 -15.4271 +557 2 15.6825 9.25538 17.3367 -2.33671 -6.91366 23.9636 +558 2 15.2177 9.29821 0.21527 -1.89476 6.92048 -0.597105 +559 1 12.0025 3.14868 18.2874 -4.08601 9.85731 -2.22671 +560 2 12.1144 3.11564 0.603374 4.33643 -8.86024 -4.9595 +561 2 12.4653 2.40747 17.863 0.0624807 -1.52737 7.22507 +562 1 13.2135 12.7035 5.12884 9.73413 0.384952 2.90661 +563 2 13.7 11.8654 5.00774 -9.98906 4.00813 0.0328844 +564 2 13.4141 12.9701 6.04548 -3.79483 -4.91087 -6.97232 +565 1 6.18903 7.09371 0.234798 3.60985 -26.8596 -14.0682 +566 2 6.2071 8.04594 18.8061 -7.0012 19.4313 6.00448 +567 2 5.26363 6.79856 0.279731 4.49735 8.94005 5.55961 +568 1 17.7003 15.89 14.853 -18.1963 11.2058 -20.3772 +569 2 16.8346 16.3247 14.8039 6.19322 -4.54728 12.6057 +570 2 17.8435 15.7325 13.9057 13.4875 -6.37623 4.18836 +571 1 13.0834 0.870867 16.8965 -0.161813 1.3846 -1.86612 +572 2 14.0072 0.582211 16.892 1.10768 1.72224 0.871652 +573 2 12.5754 18.726 16.653 1.71204 -0.315799 1.62538 +574 1 10.8945 14.507 7.48359 31.9827 12.7774 -14.5262 +575 2 10.2535 13.8684 7.76101 -18.1255 -14.8352 9.6937 +576 2 11.748 14.0397 7.49435 -7.74827 -1.48019 1.36014 +577 1 17.7521 8.40099 2.11802 -4.68381 10.101 13.2464 +578 2 16.8759 8.32923 2.50971 -7.38706 6.94009 5.95596 +579 2 17.7532 7.67887 1.5098 2.25561 -17.6604 -22.6471 +580 1 12.5231 7.84865 2.0094 -2.30264 15.9804 1.37474 +581 2 12.1379 8.74758 1.97393 9.3167 -10.0751 -1.70323 +582 2 12.325 7.4571 1.14918 -4.66948 -5.90928 2.89896 +583 1 11.972 14.5025 10.3451 -2.96888 12.9379 -2.77484 +584 2 12.1874 14.7132 9.42348 -1.74009 -6.18971 10.5862 +585 2 11.0277 14.706 10.4449 2.87573 -2.36207 -4.30421 +586 1 6.71227 6.84952 15.5806 25.6498 -3.78319 22.6581 +587 2 7.68828 6.90632 15.3859 -23.8939 0.442938 5.1849 +588 2 6.62279 7.02219 16.5478 -0.830995 -1.23763 -22.0679 +589 1 7.92027 4.40739 13.1357 7.88731 17.7005 28.4833 +590 2 7.20639 4.70613 12.563 -5.96959 3.19417 -4.54574 +591 2 8.05118 5.13552 13.7952 -2.84521 -16.8776 -20.7331 +592 1 13.2899 12.2294 14.3537 -3.3223 6.18653 6.3482 +593 2 12.9901 11.3268 14.1873 4.87208 -4.78833 3.90165 +594 2 13.6879 12.5058 13.5223 1.91273 0.0234059 -4.06458 +595 1 14.5389 9.51264 7.32918 -7.01434 -27.1539 -11.6023 +596 2 15.2763 10.0624 7.53312 20.4851 16.6908 8.43718 +597 2 13.8132 9.80854 7.861 -14.3264 8.19434 11.2695 +598 1 12.68 16.8773 3.29092 2.11558 25.6431 -8.94229 +599 2 12.7733 17.3894 4.13219 -1.2803 -9.72294 -18.9636 +600 2 12.6793 17.5234 2.53176 -0.650571 -10.0569 23.6182 +601 1 0.970813 7.05439 17.3478 19.6691 8.71735 -9.44801 +602 2 0.0997442 7.2771 17.6294 -27.888 -7.65058 15.2547 +603 2 1.07493 7.61203 16.5711 5.30897 3.90939 -5.98442 +604 1 13.0218 4.86702 15.7977 -14.5255 -22.5737 -0.430567 +605 2 13.6652 4.12206 15.7771 -2.73243 23.3382 0.768668 +606 2 13.4898 5.70142 15.8866 10.098 7.61534 -0.732483 +607 1 2.35004 3.40025 5.07686 -12.6408 -17.529 -7.45963 +608 2 1.84891 3.15034 5.87751 4.27568 5.0167 -3.29201 +609 2 2.74325 4.26374 5.21682 1.23402 6.29722 12.7184 +610 1 8.14417 10.9001 13.7499 9.28616 -30.1931 45.6744 +611 2 7.9506 10.3552 14.611 8.46781 36.9232 -44.8577 +612 2 9.00813 10.5574 13.4404 -10.6035 2.99953 -2.14266 +613 1 13.0821 1.49083 13.2989 5.3891 9.28887 -24.1834 +614 2 13.7872 1.3627 12.5959 -25.8284 12.5052 17.3021 +615 2 12.4896 2.22352 12.9857 19.0093 -19.6589 8.86348 +616 1 6.62484 13.6674 2.02561 -2.30013 1.61314 -5.1998 +617 2 5.94206 14.1599 2.51404 7.05284 -6.38204 5.2583 +618 2 7.12137 13.1184 2.65568 -4.11309 1.61678 2.96157 +619 1 15.7857 6.33001 12.4874 9.47505 -1.37582 18.5865 +620 2 16.2809 6.76838 11.7933 3.97273 7.7159 -2.96061 +621 2 16.3586 6.41799 13.2831 -12.689 -0.09302 -8.30077 +622 1 16.7471 0.613682 9.52771 11.5447 -14.6629 17.7173 +623 2 16.7567 18.2848 9.57147 -3.7535 4.88819 4.87116 +624 2 16.43 0.840462 8.66213 -13.2327 5.78697 -22.1845 +625 1 6.19152 11.681 8.24955 3.80355 -8.99636 -2.81467 +626 2 5.36879 11.4903 8.73023 3.19436 -10.2741 -4.0588 +627 2 6.55865 10.8405 7.8788 -10.8203 9.76695 14.653 +628 1 2.78766 8.56788 0.409413 -52.7319 2.11899 -11.855 +629 2 2.08185 8.03903 18.552 32.3713 20.2249 14.5342 +630 2 2.26775 9.27739 0.866586 13.6595 -12.5773 -9.56289 +631 1 10.1003 10.2385 6.61376 -10.8952 5.58665 6.62413 +632 2 10.4921 9.47201 7.04387 8.70092 -2.05853 1.95229 +633 2 10.597 10.3787 5.79806 -1.31095 -2.00825 -0.431677 +634 1 6.84539 15.7603 6.76774 -1.32488 -8.5888 0.285168 +635 2 7.15445 16.2386 7.5582 -1.07119 -0.859265 -6.52036 +636 2 7.16186 16.249 5.99512 -0.908646 8.8198 -0.167177 +637 1 6.64088 12.8596 5.99362 6.27305 7.11444 -12.0385 +638 2 6.74407 13.8044 6.07603 1.27228 12.7365 2.69296 +639 2 6.25078 12.5941 6.82297 -5.96354 -7.18103 4.5408 +640 1 16.6867 12.5722 9.84379 -3.64815 -5.06409 7.40683 +641 2 16.7505 11.8965 9.15556 3.82735 1.49832 -4.74998 +642 2 16.8024 13.43 9.4304 0.212763 1.2752 -2.86494 +643 1 6.31521 2.74143 2.73106 -6.87016 -8.03266 -4.4066 +644 2 6.55003 3.64872 2.52358 -0.655364 10.9132 -0.0341781 +645 2 5.98199 2.35933 1.9027 -1.39596 -0.0669143 5.2552 +646 1 10.642 2.89265 3.25205 -8.44131 -1.48195 -5.66324 +647 2 10.1183 3.68518 3.4139 4.92295 3.00907 1.37692 +648 2 10.2968 2.53281 2.41595 2.77965 2.00448 3.56419 diff --git a/examples/amoeba/dump.water_box.amoeba.32.test b/examples/amoeba/dump.water_box.amoeba.32.test new file mode 100644 index 0000000000..9019401850 --- /dev/null +++ b/examples/amoeba/dump.water_box.amoeba.32.test @@ -0,0 +1,7227 @@ +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.67966 7.08769 17.9461 -18.0057 -16.954 4.82612 +2 2 7.80945 6.75579 18.2607 19.8034 12.4721 -7.17463 +3 2 8.72223 6.81424 17.0254 7.13784 0.0282027 3.08606 +4 1 18.5257 8.24445 6.83762 8.52147 14.2257 60.5703 +5 2 0.216892 7.89544 6.05003 12.0964 -15.6711 -53.3384 +6 2 0.444268 7.82601 7.5302 -13.3675 6.47926 -9.3119 +7 1 8.37906 18.5504 6.81463 24.6094 6.61103 -1.11969 +8 2 9.34042 0.098069 6.73406 -18.7879 -2.64022 0.747908 +9 2 7.93962 0.573676 6.26984 -2.09268 1.16699 2.67386 +10 1 6.58995 1.84432 11.7198 46.7475 -13.739 -10.5489 +11 2 5.88543 2.40231 11.9251 -37.1346 27.545 16.57 +12 2 6.18153 1.06275 11.3693 -7.36455 -17.4045 -5.52161 +13 1 7.1466 5.75358 2.33152 -53.3657 41.599 -1.38826 +14 2 6.36812 6.12603 2.86268 38.0857 -22.9036 -2.95785 +15 2 7.02502 6.29465 1.5182 16.1101 -20.4591 11.2904 +16 1 16.2164 10.1388 16.1382 -32.9296 19.8915 17.3579 +17 2 16.9509 10.2747 15.5847 32.6569 -1.09677 -20.2087 +18 2 15.8498 11.0405 16.2399 2.59134 -12.8635 2.30838 +19 1 10.6046 15.0374 2.30369 -9.45108 -28.933 -9.95229 +20 2 10.5292 14.3949 3.01849 1.67759 -0.529274 5.48943 +21 2 11.0236 15.78 2.70962 13.2591 21.3673 6.11781 +22 1 17.1624 8.24409 10.3708 10.41 5.9387 11.3227 +23 2 16.5528 8.68798 10.966 -4.81374 9.55532 3.583 +24 2 17.9421 8.82333 10.3208 -3.63548 -8.99367 -3.64514 +25 1 14.901 15.8652 16.3167 21.2892 -10.1645 16.79 +26 2 14.0225 16.1982 16.2525 -30.7371 12.6366 -7.00126 +27 2 14.9141 15.482 17.2099 1.64171 -7.21798 -3.7798 +28 1 12.1752 13.3771 0.408263 -10.449 7.39269 11.8256 +29 2 12.0579 13.8465 18.23 5.34035 -4.48355 -17.1718 +30 2 11.6217 13.8904 1.00796 2.45905 -0.157672 9.39156 +31 1 9.27358 5.34243 4.05546 -29.354 32.8373 13.3322 +32 2 8.64594 5.4665 4.83764 23.9402 -17.6274 -26.2044 +33 2 8.74177 5.68615 3.30282 4.39732 -15.4932 8.77495 +34 1 1.83016 4.27673 11.6495 -22.4867 33.9085 -11.1027 +35 2 1.70328 5.22377 11.9391 5.26663 -24.2909 -6.35354 +36 2 2.40811 3.85345 12.2597 16.6835 -12.3735 20.3319 +37 1 1.96438 6.83299 8.3731 -11.8866 6.09586 -26.8326 +38 2 2.49614 7.21578 9.0563 11.4719 0.0715494 18.6532 +39 2 1.81128 5.90585 8.57354 7.57659 -6.58781 5.32172 +40 1 5.40557 4.38899 7.93274 -5.84675 9.40812 -2.24834 +41 2 5.53738 3.43895 7.78131 -7.95286 9.95376 -0.129754 +42 2 4.75516 4.73491 7.29062 11.2407 -18.5615 7.61563 +43 1 3.23 2.92842 17.5524 1.14755 15.2746 17.0601 +44 2 3.93109 3.19827 16.9402 0.871842 10.3641 0.782189 +45 2 3.00444 3.70897 18.1497 2.9668 -26.2705 -22.3315 +46 1 7.4624 5.26283 6.13117 4.99569 4.7543 -2.87263 +47 2 8.02565 5.58849 6.88177 -21.8117 -10.641 -11.2175 +48 2 6.93508 4.45577 6.3254 15.5754 16.5621 10.3274 +49 1 9.77896 7.02384 11.9834 11.1892 -4.91774 24.9965 +50 2 10.2721 6.37256 11.5011 12.944 -11.2243 -3.64487 +51 2 9.1532 7.31587 11.3499 -25.3515 14.1302 -21.9158 +52 1 14.1167 3.54999 8.03003 -26.7224 -2.96987 -36.9282 +53 2 13.4732 4.22413 7.73132 14.0058 -9.36539 3.16858 +54 2 14.3809 3.80189 8.88487 12.5079 17.7406 36.8421 +55 1 4.82329 17.2568 4.03846 -17.1239 31.8599 -29.451 +56 2 5.49315 17.973 4.01308 -7.2715 -20.7015 10.2799 +57 2 4.18746 17.5412 3.33843 11.1391 -13.8034 10.6312 +58 1 16.4918 16.6259 10.0493 30.7319 18.7558 -40.9431 +59 2 16.1673 16.3226 10.8594 -24.9276 -14.9205 38.9888 +60 2 15.9925 16.2084 9.33562 -5.59472 -4.21747 7.16045 +61 1 1.94489 4.93323 0.49791 29.2037 9.87254 4.22328 +62 2 2.55322 5.26335 1.2053 -16.134 -9.14189 -14.6469 +63 2 2.08253 5.591 18.4408 -15.0883 -1.49688 2.64821 +64 1 11.816 13.3571 16.2711 -9.40148 3.94995 7.41554 +65 2 11.2371 12.6203 16.5671 11.2868 -0.226619 -16.3723 +66 2 12.2446 13.1893 15.4079 -8.93504 -7.51369 10.5349 +67 1 10.105 11.0651 16.9545 19.171 -30.5561 3.11717 +68 2 10.5674 10.1947 17.1295 -13.2328 27.8223 -6.21699 +69 2 9.25349 10.8067 16.5912 -4.96621 2.04172 2.74708 +70 1 11.7264 17.5421 13.4742 -3.04385 -27.7441 -11.1528 +71 2 12.2771 16.9836 12.8968 -5.80236 0.92931 5.24929 +72 2 12.1041 18.3936 13.317 3.92972 25.4072 2.69815 +73 1 6.33029 9.31911 12.2264 14.5686 -26.7823 -24.0739 +74 2 7.02603 8.96242 11.6353 -16.9594 2.64581 0.0898615 +75 2 6.81249 9.95941 12.7172 6.645 23.591 18.9185 +76 1 16.2187 12.7249 2.70186 -8.60429 -40.8729 7.98732 +77 2 17.0292 13.1566 2.50302 21.6794 20.3416 -10.6726 +78 2 15.4982 13.3357 2.61812 -11.4268 23.7847 2.88762 +79 1 0.637202 12.5625 5.84914 -31.8402 8.87564 3.58131 +80 2 0.892312 12.5507 4.90771 -4.9886 -2.92912 11.9697 +81 2 18.3039 12.804 5.85329 37.806 -5.77498 -8.15105 +82 1 5.19922 16.3781 18.5047 -8.79571 2.1563 -13.4584 +83 2 5.80284 15.8543 17.9455 2.86332 8.92403 13.1762 +84 2 5.67034 16.9636 0.462296 7.01287 -6.10758 -1.1835 +85 1 0.510145 7.62945 4.0545 45.1401 15.6351 -20.049 +86 2 18.5719 8.14656 3.45296 8.17292 -14.6601 7.70417 +87 2 1.46496 7.74082 3.66917 -48.4928 -0.554047 23.6518 +88 1 3.14672 8.89584 6.52626 -55.2927 3.32392 -1.46176 +89 2 3.50609 8.59991 7.35294 11.5609 -2.03159 9.82262 +90 2 2.14573 8.92962 6.68203 43.6989 0.357582 -10.1043 +91 1 7.30854 10.3037 16.1717 1.78466 -0.469392 13.5048 +92 2 6.56213 10.4624 15.5802 -0.177974 -0.17468 9.69093 +93 2 6.99303 10.278 17.1118 -1.93161 2.46429 -18.5659 +94 1 11.1122 1.06968 4.98939 -2.5529 -18.3754 16.0671 +95 2 11.0776 1.97142 4.64864 2.28669 -2.46607 -13.2595 +96 2 10.7048 0.433547 4.37027 3.43033 14.549 -3.59534 +97 1 4.45204 2.70061 13.2052 -5.66348 -30.5004 33.0628 +98 2 4.60333 3.05865 14.0914 -1.92534 16.2672 -14.1546 +99 2 4.38645 1.737 13.4626 -0.349226 19.9023 -23.5316 +100 1 8.42792 10.0237 1.78469 -10.3917 -19.899 15.7952 +101 2 8.3405 10.6377 2.53622 4.61332 0.207175 -2.25283 +102 2 8.49672 9.11244 2.17467 4.01989 28.7847 -10.326 +103 1 10.5335 1.75383 15.546 -34.1458 -0.453574 1.15961 +104 2 11.3977 1.82718 15.9216 24.1476 -5.37633 -0.0681618 +105 2 10.5608 1.78317 14.5837 3.50677 3.31298 -0.339701 +106 1 2.77693 12.941 7.74821 -10.4378 -0.583625 -1.53852 +107 2 3.28797 13.5733 7.23382 6.48403 3.62296 3.43855 +108 2 1.98704 12.8256 7.20013 3.29426 -8.64685 -0.0486837 +109 1 3.63517 11.6895 5.33963 -11.8109 -10.1864 -4.68879 +110 2 3.35385 11.0502 6.03137 5.66752 13.6786 -16.6554 +111 2 2.8758 11.855 4.74058 12.1084 -4.04172 11.1294 +112 1 6.88803 14.474 16.8428 -11.4129 11.5698 10.6698 +113 2 7.55973 13.8293 16.6383 5.64016 -3.74285 -2.32739 +114 2 6.60381 14.8838 16.0165 -1.10143 -9.42407 -1.70294 +115 1 14.1722 14.5374 3.41536 22.8916 -3.95473 -24.8295 +116 2 13.6514 15.2845 3.14096 -10.2906 15.0357 0.984662 +117 2 13.8512 14.2508 4.25439 -13.7068 -8.63673 17.9444 +118 1 8.28226 18.1809 16.0824 -12.751 -14.2632 -6.38017 +119 2 8.77677 17.3494 16.3071 3.86396 27.0257 -3.69586 +120 2 8.7603 0.384816 15.9919 13.8336 -15.3184 3.9152 +121 1 4.73724 1.61643 4.90111 4.42093 34.2728 -25.3552 +122 2 3.96969 2.16837 5.15263 7.5353 -10.5013 -8.47368 +123 2 5.18465 2.1484 4.15475 -16.3947 -25.6944 40.0476 +124 1 15.1457 12.8616 16.4403 -17.2871 -9.38827 44.2976 +125 2 14.6041 12.8692 17.2613 20.1997 8.40389 -10.3991 +126 2 14.49 12.6307 15.8136 -19.9308 -5.03226 -40.1466 +127 1 15.779 18.3837 16.786 46.4421 11.1965 42.4368 +128 2 16.5108 18.615 17.4688 -40.0732 -8.23978 -31.409 +129 2 15.7694 17.4186 16.7687 -10.9286 -0.13557 -0.275231 +130 1 1.1383 1.1331 16.5571 -3.78806 10.8903 6.59298 +131 2 1.96551 1.50352 16.9177 -13.4358 3.04324 -1.88802 +132 2 0.420521 1.53444 17.0916 18.9396 -8.74897 -5.5358 +133 1 18.0817 4.5907 15.863 15.5867 -18.8741 -0.0488223 +134 2 18.5818 3.91936 15.3489 -11.2031 15.1049 7.34982 +135 2 18.5602 4.7339 16.6874 -0.349245 -1.77666 -1.18458 +136 1 12.22 16.9378 16.1148 -5.50141 -11.6153 60.0453 +137 2 11.409 16.6934 16.6676 25.9686 4.83442 -31.2532 +138 2 11.9646 17.3216 15.2917 -16.184 2.10738 -25.7541 +139 1 15.8709 2.55221 17.9707 -0.937802 24.4841 -15.6355 +140 2 15.7355 3.48355 18.2574 7.57333 -26.0521 3.95198 +141 2 15.6659 2.59235 17.0072 3.66916 -5.77112 18.206 +142 1 6.70868 13.791 10.2637 2.56639 25.7323 0.00368182 +143 2 6.59347 13.548 11.1958 -0.357243 -4.92282 -5.01928 +144 2 6.58252 13.0514 9.6765 -3.72683 -17.1721 -0.802691 +145 1 10.146 18.2027 2.80372 18.7695 36.9578 -11.0057 +146 2 10.2207 0.331961 2.18345 -3.04248 -21.6078 13.7214 +147 2 9.26571 17.8868 2.67703 -19.5044 -8.44618 -8.21612 +148 1 2.97538 17.748 6.06078 -25.8303 0.797173 6.8887 +149 2 2.09399 17.6473 5.67013 0.763714 -3.05404 12.9421 +150 2 3.45883 17.8838 5.26396 31.3429 0.483929 -10.2997 +151 1 12.558 17.0134 7.97028 5.92903 -16.4499 -7.28316 +152 2 11.9572 16.2512 7.82085 0.921176 10.9238 13.6165 +153 2 12.4657 17.4524 8.83591 -10.9555 -3.32417 -4.29455 +154 1 14.8795 15.2862 8.28544 4.29768 -18.9738 42.4504 +155 2 13.9824 15.6136 8.40666 -1.92729 9.60106 -14.0248 +156 2 15.2312 15.4641 7.43118 3.9302 10.2131 -33.7787 +157 1 17.5429 18.3228 0.375372 -51.2916 -3.32975 -15.7386 +158 2 18.116 17.6308 0.128652 39.2354 -21.6017 -8.51882 +159 2 17.9698 0.288559 0.934677 25.0864 23.4945 21.3611 +160 1 0.910209 10.3712 1.41143 1.2541 -53.8465 46.4292 +161 2 0.158544 9.88347 1.87089 19.8792 18.5163 -27.3041 +162 2 0.565924 11.0969 0.944383 -23.7591 37.8535 -27.1782 +163 1 1.55407 12.175 3.31087 17.0236 24.8743 53.6813 +164 2 1.36245 11.4802 2.72234 -7.32763 -23.5838 -35.6732 +165 2 1.61623 13.0206 2.87285 0.136729 5.19924 -18.0355 +166 1 0.543127 17.2543 4.88609 31.8084 34.0538 -50.8525 +167 2 0.11032 17.9772 5.31124 -21.3387 12.8349 12.3342 +168 2 0.420366 16.4266 5.2673 -11.294 -44.4064 35.6607 +169 1 1.10053 1.01949 9.38768 20.2638 -3.47079 3.57058 +170 2 1.46081 0.575286 10.1589 5.67003 5.93636 13.5245 +171 2 0.265613 0.594128 9.34525 -28.6257 -3.15214 -10.2647 +172 1 16.8007 2.32783 13.2877 6.99662 17.0137 -29.7497 +173 2 17.0701 2.57314 12.3549 -10.9982 -8.19012 27.7721 +174 2 16.4263 1.43993 13.282 0.147057 -7.47121 1.20179 +175 1 2.45231 15.8283 12.1942 24.161 -10.1121 18.9704 +176 2 2.8623 15.5513 13.0537 -7.72007 6.59246 -26.0318 +177 2 2.91392 15.3801 11.4615 0.0476102 5.48907 2.61928 +178 1 16.435 15.531 5.9458 18.7492 36.0842 -19.2976 +179 2 17.3808 15.5177 6.20547 -11.8351 -4.55683 5.24266 +180 2 16.4147 16.2211 5.22063 -11.381 -14.928 22.2973 +181 1 5.84547 5.02056 11.8065 17.7106 -18.2202 -11.4458 +182 2 5.55799 5.91374 11.8891 -12.2572 20.16 10.1838 +183 2 5.09 4.45915 11.9819 -6.52029 -3.58907 3.63352 +184 1 15.2214 4.86555 0.731755 -13.1216 -14.4231 22.9417 +185 2 14.6776 4.45845 1.47821 22.203 16.7553 -20.5876 +186 2 14.6696 4.95834 18.5986 -12.3693 6.08689 2.65647 +187 1 16.3401 16.2933 2.11217 18.14 -13.9799 -32.9854 +188 2 16.0666 16.7695 2.87319 -13.0548 23.8975 25.5489 +189 2 16.7601 16.9279 1.50378 -12.2165 -0.858221 10.4248 +190 1 0.305885 4.87877 3.79118 -8.03527 51.7998 21.7755 +191 2 0.299338 5.85541 4.09758 -2.9952 -44.8334 -24.4202 +192 2 1.16991 4.5635 4.03062 6.79251 -10.5604 -0.715716 +193 1 2.92501 14.9782 15.0356 -0.55527 3.1583 33.427 +194 2 3.0159 14.7264 15.9987 -0.365372 -5.40078 -25.4532 +195 2 2.35392 15.7535 15.1247 4.98076 9.37108 -6.84819 +196 1 1.1115 14.5727 9.55731 53.2995 18.2393 -15.0567 +197 2 2.08491 14.4157 9.46275 -24.2978 21.5236 -5.71591 +198 2 0.897072 13.7408 9.90248 -27.8007 -35.1999 18.1171 +199 1 13.6501 16.6688 11.5433 6.47975 17.456 -8.04391 +200 2 13.4697 17.4567 10.9694 -3.73037 -22.0736 15.6897 +201 2 13.5721 15.8897 10.9842 -9.76738 -0.866763 -1.05724 +202 1 4.73098 1.47842 0.720986 0.301824 -3.12152 0.469647 +203 2 4.27169 1.98826 0.034225 -8.26683 -3.93854 8.43126 +204 2 4.11741 0.788607 1.06182 2.96071 12.6313 -1.58966 +205 1 1.42158 18.4663 11.9139 -14.1117 26.2958 -21.249 +206 2 1.21766 0.394331 12.6648 1.16138 0.455671 2.39682 +207 2 1.94844 17.765 12.2423 13.6408 -23.7742 11.0988 +208 1 11.5498 10.1018 4.11619 25.3456 17.7005 -19.3629 +209 2 11.5687 10.5955 3.24216 -3.14233 -16.3641 23.7483 +210 2 12.4899 10.1059 4.45555 -25.4417 -1.6091 -14.3563 +211 1 8.38254 12.182 3.76573 -28.852 -4.31545 3.66513 +212 2 9.25863 12.501 4.06076 -17.1001 4.9792 7.32521 +213 2 7.63736 12.4251 4.40785 39.3791 -3.23553 -14.7997 +214 1 14.3228 4.03714 3.29709 9.27375 -1.14036 13.2131 +215 2 14.8928 4.14179 4.10547 -9.51715 0.900554 -20.2647 +216 2 13.4701 4.45558 3.48891 4.64833 -1.13545 4.69814 +217 1 5.58188 1.78199 7.50513 -29.4992 -43.0538 46.7434 +218 2 5.0172 1.13958 8.12095 30.2312 35.5173 -41.7355 +219 2 5.33078 1.59122 6.59529 -0.079259 -3.9625 -11.0752 +220 1 17.9086 1.12503 4.88467 2.95857 -4.16946 -9.18468 +221 2 18.4038 1.54032 4.14207 -4.82318 -1.26447 16.1692 +222 2 17.6814 1.78344 5.55455 4.62183 1.86586 -4.7268 +223 1 6.83101 9.39303 4.49716 -16.0719 2.4093 -32.0921 +224 2 6.83675 9.57499 5.42715 5.68499 0.0447418 21.7322 +225 2 7.66807 8.99049 4.24996 11.5264 2.90932 7.40733 +226 1 2.71406 14.9654 1.962 -15.6661 -3.22344 -28.3015 +227 2 3.33343 14.7912 2.66354 12.1361 -6.91733 6.37301 +228 2 3.09502 14.6645 1.10257 -2.31521 10.6903 23.881 +229 1 17.279 12.8803 13.1283 -15.852 18.187 11.8592 +230 2 16.4044 13.2339 13.3283 -9.52452 -19.4408 0.302495 +231 2 17.6948 13.7346 13.0834 29.0619 4.95471 -11.8483 +232 1 15.0196 10.5818 1.38314 -38.2265 -36.9922 -31.977 +233 2 15.5102 11.1963 1.85791 34.2907 40.991 28.9525 +234 2 14.3351 11.0964 0.933298 3.32659 -5.3471 5.33786 +235 1 5.71789 6.95838 4.52856 0.683996 -27.8748 7.64407 +236 2 5.85266 7.87985 4.34179 3.58991 17.4746 0.820156 +237 2 6.44364 6.70841 5.13514 -10.315 -1.76088 -5.92415 +238 1 8.12142 8.26262 10.159 -0.695069 1.43108 44.445 +239 2 8.58519 8.93965 9.66877 7.60931 4.76567 -12.7632 +240 2 7.56021 7.74854 9.59836 -11.8614 -6.52029 -23.2391 +241 1 13.5311 18.2901 5.8079 -10.639 -13.2321 14.1155 +242 2 12.703 0.102298 5.56963 3.89465 4.4637 5.13268 +243 2 13.2939 17.6289 6.50758 1.00889 22.2284 -14.4481 +244 1 0.327324 2.56344 0.113251 1.70035 12.7901 -0.992224 +245 2 18.009 2.52214 18.5736 8.63965 15.9711 4.89881 +246 2 0.724331 3.48299 0.160564 -21.1536 -24.6374 0.514976 +247 1 12.6396 10.9599 9.76875 -56.8672 19.3176 -11.2335 +248 2 11.6552 10.7306 9.75031 35.1307 23.7735 -5.55284 +249 2 12.944 10.1383 10.0842 27.9729 -33.5927 10.4043 +250 1 0.789377 12.2851 11.08 11.4395 6.49483 14.2632 +251 2 18.4919 12.3017 11.2021 -18.2818 -3.30898 -6.09679 +252 2 1.09088 12.7637 11.8722 5.75277 -12.0493 -6.6955 +253 1 5.04567 7.2193 13.4912 -21.0137 -4.20407 -15.1033 +254 2 5.59899 7.84649 13.0247 8.33052 12.0635 4.31379 +255 2 5.48047 6.97898 14.3058 12.3979 0.954472 8.53674 +256 1 1.28609 6.99027 11.837 -51.8154 -68.8711 -15.2848 +257 2 0.481329 7.14037 11.2978 13.8945 0.267944 10.341 +258 2 1.71601 7.79102 11.8803 31.2664 60.1884 9.92158 +259 1 15.4442 9.46712 12.3088 17.5832 34.764 29.4487 +260 2 15.6103 10.4448 12.4444 -11.1607 -30.7672 -13.8763 +261 2 15.5582 9.10301 13.208 -6.74487 -0.409264 -16.2653 +262 1 16.6404 12.9744 5.44078 0.476019 -21.9889 6.56196 +263 2 16.2955 13.8866 5.54247 3.20084 -14.9841 -16.6056 +264 2 16.51 12.593 4.54035 -6.85686 22.0547 12.2483 +265 1 6.17495 10.0683 0.210584 -24.8048 -7.78292 -31.6597 +266 2 5.35839 10.4511 0.557392 3.36584 -0.936069 -2.46609 +267 2 6.76092 10.0813 0.943985 27.7338 0.90169 16.297 +268 1 12.3644 6.05734 4.04236 -18.3706 -38.3329 30.2118 +269 2 12.4738 6.70802 3.38308 -4.23006 32.9396 -25.2938 +270 2 11.4212 5.77124 4.03221 17.6012 8.78206 -0.800798 +271 1 0.124733 12.8266 0.203961 3.20067 -1.28022 -4.47052 +272 2 0.029974 13.5935 0.786871 -4.13202 -3.19163 0.984476 +273 2 18.185 12.9963 18.0877 7.32574 2.49628 4.77591 +274 1 3.83931 18.5785 8.61972 20.3146 -6.32916 -11.386 +275 2 3.58625 18.36 7.70531 -8.03976 -3.33875 5.01892 +276 2 3.07994 0.282626 9.06556 -19.534 7.19375 -0.404578 +277 1 7.37599 17.2741 4.45241 46.8945 31.0513 1.9622 +278 2 8.02493 17.9603 4.76808 -26.2103 -24.7083 -3.79352 +279 2 7.47725 17.3636 3.49301 -14.0292 -8.10987 6.13371 +280 1 9.20909 17.0315 12.2197 40.0448 -1.21715 18.2255 +281 2 9.48765 16.172 11.8421 -14.9023 11.2095 -3.08284 +282 2 9.99892 17.2887 12.7762 -22.6762 -6.36186 -10.9913 +283 1 13.3284 13.0292 7.94175 -54.0325 -32.963 -10.3586 +284 2 13.0533 12.253 8.47808 14.6554 7.99008 1.85075 +285 2 14.1985 13.2855 8.14946 35.8516 11.3519 14.341 +286 1 14.9871 2.94126 15.3478 14.8638 12.3357 -7.44451 +287 2 14.2243 2.52816 14.9303 4.35222 -7.49481 -2.56315 +288 2 15.7054 3.02501 14.6718 -19.1947 -5.47381 11.1555 +289 1 9.85637 15.4939 17.0026 4.34281 7.61827 -6.92944 +290 2 10.2013 14.6312 16.7411 4.19591 2.79737 -1.68983 +291 2 9.35728 15.3668 17.8085 -9.66212 -2.87408 7.84053 +292 1 11.2848 8.23994 16.5492 3.25751 34.7591 1.5155 +293 2 10.8315 7.75123 15.8747 -12.3664 -15.1549 -6.58201 +294 2 11.7506 7.62533 17.1016 5.33248 -14.8245 8.28699 +295 1 3.77097 18.1898 16.7118 4.01905 33.5947 11.0152 +296 2 4.24576 17.6768 17.3569 8.65949 -22.0954 6.28955 +297 2 3.7978 0.441972 17.1008 -4.25038 -14.6471 -12.4326 +298 1 2.20581 4.09889 8.95874 2.08991 2.93543 4.28652 +299 2 3.00197 3.55544 8.74643 -14.7124 14.9899 14.3923 +300 2 2.10364 4.24367 9.94001 10.2614 -16.6264 -23.5165 +301 1 9.9196 10.3581 9.75231 -25.3187 14.4865 -18.1673 +302 2 9.34403 11.1055 9.40387 23.5511 -18.6954 16.391 +303 2 9.87032 10.282 10.7171 2.48436 10.3271 -7.39297 +304 1 9.73405 0.807167 10.8572 20.2474 21.386 4.54274 +305 2 9.58177 18.5811 11.2204 -17.7151 -14.7389 -0.277185 +306 2 9.10878 1.03014 10.1675 -11.7891 -3.63679 -6.29284 +307 1 9.18221 15.2247 10.2123 -13.9791 -9.46207 -17.3808 +308 2 9.04674 16.0847 9.7631 0.486754 -17.6411 9.75771 +309 2 8.3908 14.6843 9.94105 18.1048 12.7648 16.7376 +310 1 1.00316 9.27987 10.329 16.2357 -30.0069 -12.307 +311 2 1.16727 10.1904 10.5724 12.5584 13.4462 -0.132091 +312 2 1.84996 8.76119 10.1498 -29.1191 35.4904 9.82697 +313 1 16.8004 4.89338 8.19813 20.3933 -12.8673 28.5682 +314 2 16.1748 5.31624 8.83318 13.8703 -8.22156 -17.3769 +315 2 17.4877 4.38941 8.71628 -28.7666 17.1718 -13.9408 +316 1 14.6379 14.6893 0.402347 -11.3933 -1.08114 12.583 +317 2 14.9609 15.3376 1.05877 1.73558 -10.8431 -5.12344 +318 2 13.9048 14.1906 0.841144 16.133 14.0369 -13.7985 +319 1 3.51181 11.0525 9.63829 3.71178 7.51059 -9.42611 +320 2 3.41507 11.3617 10.5484 4.21267 3.5616 -2.2445 +321 2 3.25155 11.8076 9.06383 -1.86739 -11.3951 3.16022 +322 1 11.0289 10.8695 1.26208 17.5529 18.9634 -6.32419 +323 2 11.1535 11.716 0.753779 -2.53448 -25.7082 13.9861 +324 2 10.1142 10.5923 1.16471 -5.76816 1.63272 -1.45278 +325 1 13.2239 7.06188 12.8977 -31.5053 10.0751 -2.41927 +326 2 14.1381 6.84046 12.8922 27.4331 -7.40558 0.979603 +327 2 12.7471 6.22139 12.9668 2.74296 5.12722 -5.48309 +328 1 9.62584 1.88878 0.937813 20.2039 -2.98483 37.6532 +329 2 8.77484 2.11506 0.623903 -27.5663 2.83673 -14.773 +330 2 10.1764 1.70882 0.191067 9.03311 -1.803 -18.3794 +331 1 10.6054 13.537 4.7508 -5.88392 -4.211 -2.61457 +332 2 11.3208 12.9359 5.04367 -2.43279 15.5075 -5.53386 +333 2 10.4128 14.1619 5.47507 10.6777 -11.2442 -5.71889 +334 1 14.2525 1.6915 10.8868 22.6682 20.2673 6.9187 +335 2 15.0842 1.26497 10.6465 -0.175006 -8.05208 -4.1062 +336 2 14.5069 2.62992 10.8824 -12.4791 -0.486299 1.09093 +337 1 14.6678 12.4248 11.7157 -13.2082 -11.6835 -6.16669 +338 2 15.5574 12.5766 11.3177 -21.8957 -10.6844 -5.73724 +339 2 14.0022 11.9667 11.1187 29.6297 15.7618 7.64488 +340 1 8.24065 5.08218 9.78509 -6.47861 44.5837 29.4664 +341 2 7.45364 5.10173 10.3836 14.047 -11.9893 -18.2698 +342 2 8.36822 4.22882 9.41503 -9.58488 -33.9934 -8.19516 +343 1 1.59893 16.8132 18.3262 1.96117 45.1636 -18.3395 +344 2 1.99225 17.1675 17.4932 -11.7114 -3.37836 17.8399 +345 2 1.72693 15.8931 18.2458 8.8364 -33.8164 2.61771 +346 1 1.43382 17.2563 15.3383 72.5903 -10.7327 -13.0674 +347 2 1.32309 18.1562 15.5759 -7.01853 28.114 11.2541 +348 2 0.623143 16.841 15.3782 -65.0193 -20.0106 1.99827 +349 1 3.73599 5.55499 6.2196 -15.153 37.171 -3.6345 +350 2 3.32092 6.26594 6.76194 -0.427016 -18.6419 -6.59332 +351 2 4.19567 6.05321 5.52665 9.16489 -2.39818 -0.177123 +352 1 12.357 9.41487 14.1826 14.7553 -23.0333 -0.513454 +353 2 12.9591 8.63784 13.9021 -31.7094 29.7183 13.6876 +354 2 11.936 9.15457 15.0346 15.6336 0.764049 -11.787 +355 1 4.0362 15.2647 6.90572 29.1452 22.7898 -8.55589 +356 2 3.45744 16.0249 6.7945 -6.03593 0.633302 -6.25525 +357 2 4.92941 15.6518 6.66696 -24.7672 -22.8121 8.07817 +358 1 0.606517 8.56128 14.8606 8.16327 11.3924 -6.42857 +359 2 0.498099 9.52604 14.9437 -1.3098 -5.53798 5.35752 +360 2 1.28855 8.50016 14.167 -7.84877 -5.15776 5.22176 +361 1 12.9763 8.3683 10.3434 -0.844759 8.90572 -31.1716 +362 2 13.7163 7.90436 9.89822 -4.62341 -2.31264 17.3373 +363 2 12.9003 8.0957 11.2534 8.39581 -13.8091 14.665 +364 1 15.2983 7.63672 3.47583 -36.1974 -22.3868 30.0346 +365 2 14.5024 7.10501 3.29647 15.8969 13.8763 -24.8874 +366 2 15.2922 7.47095 4.43335 27.1257 13.219 -1.62631 +367 1 17.3208 6.63818 0.028906 -14.8751 21.4285 -7.11338 +368 2 16.7479 6.05403 0.554933 2.23596 0.744461 -7.2242 +369 2 16.7141 7.27151 18.2009 9.57247 -21.991 17.917 +370 1 8.79355 6.92545 7.84172 -22.0329 -24.5159 21.3067 +371 2 9.63968 7.32585 7.85068 36.717 16.3192 -5.46325 +372 2 8.77688 6.39871 8.67404 -5.56167 6.19415 -17.3543 +373 1 12.3209 0.607808 1.1741 -8.60043 -0.59496 -5.94607 +374 2 12.995 1.15082 1.58835 11.0262 -7.11766 4.69751 +375 2 12.79 18.5825 0.66073 -1.01688 3.73434 3.9163 +376 1 5.68514 15.097 14.5145 8.08213 26.2607 -13.8654 +377 2 4.72797 15.1695 14.4772 -8.65505 -1.66018 8.38379 +378 2 6.02476 15.8935 14.032 -4.56821 -16.9623 16.8148 +379 1 3.822 6.53853 1.67803 10.5239 -7.29529 -10.476 +380 2 3.54968 7.33117 1.17576 -0.94291 -9.86176 19.1013 +381 2 3.81642 6.7886 2.60252 -1.1437 7.90849 5.70077 +382 1 3.89262 11.6088 12.227 12.6183 0.535598 5.61903 +383 2 4.72051 12.1032 12.348 1.21499 -6.42147 -0.654839 +384 2 3.26281 12.0921 12.7526 -15.9809 8.56892 5.74885 +385 1 5.45444 3.88172 15.8755 8.44756 62.1439 23.7417 +386 2 5.90627 3.24049 15.3708 26.1603 -31.2362 -14.1171 +387 2 6.11665 4.65725 15.9739 -35.5554 -35.0069 -5.06549 +388 1 14.4636 10.317 4.39501 5.54347 -18.2961 -43.8287 +389 2 14.9051 9.88853 5.13417 0.162303 -5.91623 3.64337 +390 2 14.7084 9.81768 3.53446 -11.8135 21.0668 42.8202 +391 1 7.94949 17.2895 9.24469 -10.6799 8.8199 -1.02562 +392 2 7.23447 17.5423 9.86969 8.35341 2.50468 -15.9799 +393 2 8.01085 17.8889 8.47627 -8.2125 1.31495 9.33291 +394 1 4.4986 14.4237 3.96317 23.4879 4.54475 27.495 +395 2 4.89523 15.3318 4.14709 -14.6852 -27.1979 0.729547 +396 2 4.80237 13.7713 4.67129 -11.1841 28.5155 -20.9146 +397 1 14.3358 7.38467 15.7635 18.2582 5.36164 1.70543 +398 2 15.2401 7.23754 15.391 -25.5283 4.5174 14.2628 +399 2 14.4998 7.83446 16.6232 -7.00614 -11.7321 -15.3353 +400 1 2.86875 18.2246 1.90934 11.7547 29.7641 47.6357 +401 2 2.54447 17.7626 1.17928 -20.4445 -34.8995 -41.4626 +402 2 2.08284 18.4154 2.45796 12.4063 3.86937 -8.17484 +403 1 7.96139 1.61197 4.52525 30.3503 -5.61589 29.1814 +404 2 7.4985 1.83317 3.72811 -5.85178 12.6793 -14.6648 +405 2 8.84188 2.051 4.57628 -22.8061 -6.44347 -10.2559 +406 1 2.69247 14.1251 17.7583 -44.9975 -8.30966 9.027 +407 2 1.78944 13.8074 18.0556 29.9332 0.951363 -12.1679 +408 2 3.33089 13.517 18.1683 -0.885538 6.08231 -6.55793 +409 1 0.711797 1.68055 13.8626 46.1903 -0.903658 -18.4125 +410 2 0.854596 1.56791 14.7929 -3.1534 -4.53792 18.4431 +411 2 18.4557 1.86826 13.7064 -36.4408 7.03813 3.66844 +412 1 4.5582 18.5986 13.9691 16.7448 -5.62304 -20.7496 +413 2 5.37614 18.0918 13.7297 -17.5024 17.6116 13.2075 +414 2 4.4096 18.4453 14.9034 -5.9637 -5.97884 8.59903 +415 1 7.10973 0.453475 18.3742 -15.9095 45.4284 35.234 +416 2 6.99644 0.098599 17.5235 1.36411 -17.312 -40.4978 +417 2 6.34312 1.05085 18.5323 11.251 -17.9428 -0.916775 +418 1 16.0934 18.4421 14.1505 -12.1616 -21.5095 -38.715 +419 2 15.444 17.7866 13.7542 19.2119 24.6311 23.4234 +420 2 16.0379 18.4915 15.109 -11.392 0.0248185 1.48898 +421 1 10.1156 4.52417 16.2956 -62.1497 -10.7811 -30.3439 +422 2 10.9808 4.34247 16.5381 55.5233 -0.530433 19.4573 +423 2 9.84863 3.69679 15.8473 1.30878 12.8229 10.5952 +424 1 15.8226 17.9425 4.41327 -8.6596 2.53656 28.4341 +425 2 16.5547 18.5732 4.53052 -7.53986 -1.28134 -1.76301 +426 2 15.1071 18.2295 5.06915 24.8326 -13.5436 -35.3744 +427 1 6.9246 17.3574 13.7412 35.4232 12.1969 -4.79491 +428 2 7.49648 17.8115 14.4369 -19.095 -19.6264 -17.6052 +429 2 7.52703 17.1963 12.9658 -8.44681 6.90552 21.4872 +430 1 13.2892 6.57209 6.73437 -47.4462 -6.01427 11.894 +431 2 14.2146 6.66317 6.83486 37.5911 0.460957 -13.6759 +432 2 13.0394 6.38579 5.82242 8.60231 0.411312 -6.48828 +433 1 7.6616 2.3861 9.17526 11.1339 -5.58665 -35.6695 +434 2 7.32169 2.39592 10.0555 -17.0215 -5.04529 20.6135 +435 2 6.95914 2.1022 8.53308 18.7558 7.43711 21.2842 +436 1 15.1464 14.8771 13.6482 -7.73724 1.21311 0.537171 +437 2 15.0308 15.0223 14.6069 -1.84691 1.26092 -11.2626 +438 2 14.3194 15.1152 13.1798 14.9291 -3.65447 11.731 +439 1 9.29105 8.34315 3.70472 21.3149 -22.535 5.81715 +440 2 10.1776 8.75859 3.73678 -10.082 3.55323 2.49013 +441 2 9.48378 7.39942 3.88081 -6.26995 14.6936 -2.40173 +442 1 17.6854 13.4687 16.4528 7.27147 30.461 -18.2669 +443 2 16.7357 13.4337 16.3398 -4.89197 -8.49248 4.47316 +444 2 17.8844 14.3284 16.0065 3.65909 -18.1112 10.9221 +445 1 5.04883 10.6547 2.58751 22.4142 -14.5409 3.1837 +446 2 5.87017 10.3468 3.04382 -22.783 5.18619 -3.79272 +447 2 4.55197 11.1441 3.22928 -6.35653 9.92745 13.9967 +448 1 3.70566 8.3683 10.3381 0.421872 -35.3081 -1.7593 +449 2 3.86061 9.29726 10.2176 3.60826 23.2513 -1.90293 +450 2 3.86652 8.14601 11.2715 -1.83662 8.64514 -7.63686 +451 1 16.1079 7.11641 6.33859 18.7251 -13.7954 -9.96454 +452 2 16.7241 7.70559 6.80408 -7.87205 -5.85527 -7.24175 +453 2 16.6678 6.33083 6.12136 -22.8952 10.0887 6.36104 +454 1 15.2027 7.00502 9.1117 -13.5711 31.2066 -33.9348 +455 2 16.009 7.42176 9.46585 -10.2898 -7.03399 -7.73296 +456 2 14.9881 7.51375 8.25647 13.8068 -20.3115 41.0185 +457 1 6.4525 13.1649 12.9201 -16.9811 1.25576 1.12717 +458 2 7.2977 12.7289 13.0561 1.55279 -4.02118 8.73008 +459 2 6.25327 13.7237 13.7059 9.12735 -9.15034 -19.1848 +460 1 12.1145 4.49786 13.0694 62.3048 41.2439 -0.723073 +461 2 12.3852 4.68406 13.9868 -14.3297 -10.0558 -0.292641 +462 2 11.3952 3.9317 13.0199 -52.2119 -35.1204 4.15665 +463 1 11.3323 8.18365 7.8522 27.7169 3.03613 12.328 +464 2 12.0901 7.73501 7.43634 -12.9205 -4.29619 -7.69129 +465 2 11.7651 8.45102 8.68662 -18.4456 -0.736999 -3.04515 +466 1 17.1666 10.776 7.42179 36.4822 -17.3878 -25.363 +467 2 17.7906 10.0723 7.08441 -17.5934 13.4566 22.3886 +468 2 17.2793 11.4524 6.73733 -15.3427 2.84073 7.18141 +469 1 5.22802 18.1471 11.05 -23.1388 -14.8798 2.48444 +470 2 4.73762 18.1049 11.901 7.4508 0.565766 -17.6495 +471 2 4.62535 17.7417 10.374 17.7336 12.8347 12.9373 +472 1 7.56653 17.6363 1.80821 4.35794 -3.26776 57.5888 +473 2 7.65741 16.7768 1.42856 9.05039 -19.6913 -22.9027 +474 2 7.35855 18.2549 1.13994 -1.37991 13.1573 -30.1972 +475 1 1.85092 12.9256 13.6076 18.7065 20.702 19.2299 +476 2 1.72104 12.4156 14.4258 -5.54537 -0.960406 -11.4426 +477 2 2.19932 13.7866 13.9501 -8.88955 -22.8153 -6.43965 +478 1 9.73868 6.79159 14.8001 -20.0718 45.6966 0.235719 +479 2 9.95236 5.95211 15.1529 12.0129 -40.6355 11.2206 +480 2 9.967 6.84408 13.8723 5.59208 -5.10263 -8.66058 +481 1 15.2087 4.3972 10.7794 -27.6923 -26.0969 -27.5028 +482 2 16.0082 3.89203 10.8637 26.1176 6.2885 5.33656 +483 2 15.2102 5.16148 11.3322 8.48984 16.211 19.3779 +484 1 11.1963 6.12482 0.150068 -21.1972 -23.7011 14.8212 +485 2 11.2381 5.20796 0.481504 11.4486 12.9471 -10.1704 +486 2 10.2374 6.21547 18.6186 14.0424 14.8346 -3.67395 +487 1 0.19533 11.3359 15.1413 -20.6703 11.3325 -28.7309 +488 2 18.4021 11.874 14.3993 9.91215 -19.3636 27.3138 +489 2 18.4481 11.661 15.9631 4.36494 9.01906 -3.16307 +490 1 7.06882 9.13032 7.26059 -19.4655 -1.24154 14.8953 +491 2 6.55985 8.40099 7.69941 12.6354 16.9737 -16.1687 +492 2 7.9725 8.82922 7.21375 8.43039 -5.65083 0.275054 +493 1 18.4578 15.4507 12.3537 3.87705 -1.0699 -4.92487 +494 2 0.776651 15.5698 12.2511 -12.7177 -2.03387 6.80581 +495 2 18.1456 15.6789 11.4721 -4.67377 -0.406651 0.743757 +496 1 16.5694 4.36967 5.25107 0.98709 -29.8421 42.9348 +497 2 16.7744 3.81151 6.06026 -19.0257 27.4778 -23.1846 +498 2 17.3898 4.32671 4.78168 15.572 7.21618 -21.1326 +499 1 17.788 3.06911 10.7078 7.64381 16.9425 17.2861 +500 2 0.075758 3.1322 11.0257 -14.4921 -2.82201 -9.29777 +501 2 17.6332 2.20749 10.3226 4.29805 -13.9207 -6.70838 +502 1 12.3142 0.064083 10.1758 -16.2036 46.6093 2.93236 +503 2 11.3746 0.384648 10.259 24.7548 -16.9496 1.0795 +504 2 12.8178 0.919304 10.3228 -10.1981 -36.9052 -8.89593 +505 1 10.3666 9.83315 12.2981 10.0643 6.74252 24.9843 +506 2 11.1015 9.85063 12.955 -7.48254 2.69098 -11.3777 +507 2 10.1328 8.91188 12.2898 -1.25875 -17.3524 -2.69444 +508 1 0.463654 2.82678 7.01839 23.1504 30.9543 10.494 +509 2 0.875324 3.58845 7.48211 -15.8261 -9.71426 -11.3384 +510 2 0.770257 2.12665 7.58365 -2.51696 -19.6875 3.88184 +511 1 0.478371 15.2358 6.91004 -5.36214 -57.1351 9.88058 +512 2 0.585298 15.6463 7.75647 2.33624 13.0536 15.0713 +513 2 0.556531 14.2524 7.18353 -2.6234 48.5984 -27.3232 +514 1 16.9534 7.00251 15.3394 -19.8576 7.98442 -8.98385 +515 2 17.6338 7.63543 15.0899 18.202 -5.57661 4.9227 +516 2 17.3093 6.19568 15.7235 12.2576 0.0838452 -6.46227 +517 1 9.0001 12.4151 8.13768 -31.7276 34.3494 27.7642 +518 2 9.37386 11.8218 7.49742 -2.69042 -17.0115 -24.8182 +519 2 8.02402 12.632 8.03373 37.271 -17.4326 -7.14384 +520 1 1.27238 1.95406 3.05803 -14.2139 -9.70678 -17.9319 +521 2 1.26084 2.61511 2.34121 0.72572 -7.36998 11.1944 +522 2 1.89031 2.22344 3.73293 7.71835 10.2015 -2.21509 +523 1 4.13907 15.1156 9.62039 -24.138 8.67184 14.727 +524 2 4.07003 15.1439 8.65747 7.76366 -2.53025 0.663124 +525 2 4.96029 14.7006 9.86457 16.019 -6.11163 -3.79055 +526 1 7.17628 2.17866 14.5671 8.05543 15.8774 -0.750343 +527 2 6.99528 1.68402 13.7698 -4.08254 -5.57585 -6.74919 +528 2 7.62131 2.98432 14.249 -3.31184 -9.11349 9.13274 +529 1 18.6082 14.7131 2.1481 32.1263 -19.3615 -2.59353 +530 2 0.838003 15.1297 2.25966 -2.55576 -5.62694 -3.02712 +531 2 17.988 15.3544 2.42675 -29.4597 23.3621 5.14018 +532 1 9.94138 2.79524 12.9422 18.0301 -20.084 -2.65944 +533 2 9.79404 2.1456 12.2228 -2.72579 10.1868 5.0837 +534 2 9.17835 3.36299 13.0326 -9.76513 7.42125 -6.32672 +535 1 2.80444 8.90955 13.0076 -21.3878 -12.6555 -0.633582 +536 2 3.06361 9.80599 12.872 11.8276 24.8177 -4.92621 +537 2 3.5122 8.48618 13.4775 16.8101 -10.8298 6.5617 +538 1 3.236 8.3574 3.63664 -3.24123 -25.7508 65.6997 +539 2 3.45085 9.0718 3.07326 14.699 31.6407 -15.7982 +540 2 3.47645 8.58669 4.60794 -10.8292 -3.55345 -46.4885 +541 1 5.62853 7.18594 8.51094 13.0444 23.9613 2.26298 +542 2 5.46784 6.31815 8.13889 -4.11832 -12.799 10.1434 +543 2 4.96415 7.47792 9.15047 -6.22666 -11.1251 -0.517113 +544 1 14.8757 1.26039 2.01768 6.89853 7.12439 -27.6668 +545 2 14.9353 2.01952 2.56559 -6.08088 15.4811 28.5729 +546 2 15.2784 1.60993 1.21235 -3.12956 -15.001 -5.59525 +547 1 8.22892 15.2012 0.850139 9.01324 -8.86779 5.43529 +548 2 9.02213 14.9338 1.33488 4.41045 13.1537 -1.08033 +549 2 7.55366 14.6663 1.27665 -10.9347 0.418265 -6.06235 +550 1 15.6387 1.34587 7.23673 -34.4855 -14.424 -6.72803 +551 2 14.9277 0.724731 6.91269 25.2779 16.6902 6.4887 +552 2 15.1173 2.1119 7.53894 8.3028 -0.775331 -5.89355 +553 1 4.90142 13.0959 18.5232 17.5611 -6.682 24.5871 +554 2 5.32755 13.082 0.76977 -9.23128 1.69535 -18.7742 +555 2 5.44764 13.7122 18.0259 4.92611 -3.73779 -6.82361 +556 1 15.3368 8.46948 18.1479 24.407 23.6523 -18.6734 +557 2 15.8061 9.12264 17.5623 -15.0725 -19.5419 9.94084 +558 2 15.3318 8.91689 0.353875 -7.67765 1.6761 7.06822 +559 1 12.0708 3.01842 18.3809 -8.57811 34.9919 -15.9288 +560 2 11.9316 2.65996 0.60646 7.37996 -15.8634 5.79137 +561 2 12.6022 2.47389 17.7995 4.55547 -17.8211 5.72515 +562 1 13.2139 12.6752 5.17768 -11.8856 9.18106 -10.9384 +563 2 13.7464 12.0348 4.69253 2.29692 -7.56952 8.05888 +564 2 13.2564 12.5123 6.11793 11.0077 -2.72782 9.02039 +565 1 6.05443 7.0356 0.031519 0.145276 -19.8641 5.27909 +566 2 5.93935 7.95118 18.5019 2.68887 36.361 -1.99394 +567 2 5.39095 6.86665 0.702638 -10.5375 -11.3291 0.555603 +568 1 17.7528 16.0276 15.0213 -26.9751 8.08167 9.65398 +569 2 16.9476 16.5457 15.105 2.62193 -2.13449 20.9775 +570 2 17.7479 16.0055 14.0813 23.0391 -15.2709 -33.7916 +571 1 13.196 0.994907 16.5363 6.64944 3.5152 15.0268 +572 2 14.1481 0.997912 16.7614 -13.0846 -5.94027 -6.50206 +573 2 12.8833 0.094199 16.7238 3.13951 3.25376 -8.62791 +574 1 11.1253 14.5647 7.20271 12.6179 20.8985 -18.374 +575 2 10.4007 14.3183 7.72981 -32.928 -10.0181 24.5345 +576 2 11.7186 13.8255 7.26943 16.9686 -3.76464 3.70387 +577 1 17.5081 8.62849 2.08107 18.4536 39.9223 21.5452 +578 2 16.6801 8.63471 2.55495 -14.8656 -12.3201 1.9096 +579 2 17.5233 7.88242 1.516 -5.44609 -31.2556 -23.2052 +580 1 12.3547 8.01168 2.02213 3.34817 7.10659 0.607451 +581 2 12.2384 8.8582 1.54611 -2.17098 -11.1853 7.9144 +582 2 11.9739 7.3152 1.48261 -5.38076 0.52639 -15.2068 +583 1 11.8761 14.6165 10.3364 1.47614 -26.5661 -12.796 +584 2 12.1004 13.7873 9.81464 -15.4397 33.1565 21.8304 +585 2 10.8993 14.6888 10.473 20.8283 -4.95583 -12.7008 +586 1 6.89524 7.05211 15.6117 0.948881 6.37495 10.6055 +587 2 7.81004 7.26536 15.3122 -15.6925 -0.985911 8.93516 +588 2 6.66676 7.54167 16.4408 13.3623 -9.35483 -24.2683 +589 1 8.00326 4.73593 13.4743 46.4542 16.9938 22.3473 +590 2 7.23337 4.7302 12.9572 -38.0428 3.58552 -28.1525 +591 2 8.40671 5.62958 13.343 -10.0413 -24.497 3.68285 +592 1 13.4128 12.1818 14.2522 -5.09814 -0.706424 13.2965 +593 2 12.9414 11.3292 14.2657 9.08717 -0.174959 -7.02282 +594 2 13.7875 12.315 13.3696 0.74786 -2.13255 -0.749325 +595 1 14.8395 9.42189 7.30548 -8.6508 -34.4179 -15.7659 +596 2 15.7087 9.765 7.42505 16.3683 18.0856 5.12693 +597 2 14.2269 10.0768 7.57319 -16.6679 19.7312 11.3719 +598 1 12.6526 17.0686 3.07252 -27.098 39.8252 10.9251 +599 2 12.8376 17.5237 3.93373 4.63929 -18.9198 -22.9156 +600 2 11.9913 17.6958 2.63477 30.4514 -31.1971 13.898 +601 1 1.15545 7.13838 17.4647 3.17244 9.59861 -23.4243 +602 2 0.330359 7.36323 17.9184 0.96629 -9.78644 0.159833 +603 2 1.05514 7.47868 16.5422 0.732192 -3.11516 17.9471 +604 1 12.7562 5.15096 15.6457 43.4314 -6.34677 13.892 +605 2 13.4512 4.55662 16.0315 -22.7809 11.2033 -14.7919 +606 2 13.2414 6.00335 15.5788 -11.6166 -6.13865 2.23982 +607 1 2.53993 3.38757 4.97618 -22.6627 40.6834 48.2045 +608 2 1.7609 3.18232 5.58922 26.9518 1.19035 -20.1247 +609 2 2.84154 4.31546 5.27885 -5.90416 -46.089 -11.2441 +610 1 8.33186 11.2983 13.4548 -26.6082 5.68838 43.1719 +611 2 8.4244 11.0562 14.4444 7.75654 0.873515 -50.9507 +612 2 8.91168 10.8786 12.8197 22.3442 -13.0535 12.4472 +613 1 12.8689 1.31514 13.3384 2.90045 58.5941 -12.9641 +614 2 13.42 1.58034 12.5659 -7.54964 -19.9936 10.3698 +615 2 12.4231 2.17844 13.5496 8.73522 -32.0886 -3.11014 +616 1 6.34008 13.7169 2.14963 -18.1698 -8.87317 18.5321 +617 2 5.63978 13.877 2.82959 15.2612 6.49493 -20.3543 +618 2 6.88351 13.0442 2.56282 10.2537 -4.17084 0.110729 +619 1 15.9206 6.61444 12.7992 -24.6515 -28.5257 0.353752 +620 2 16.3106 7.25195 12.2393 18.8127 19.5603 -18.6955 +621 2 16.4213 6.59661 13.608 8.17022 1.84551 14.3752 +622 1 16.8298 0.712824 9.59482 4.92561 -19.6459 1.56363 +623 2 16.8791 18.3713 9.72616 -6.7933 22.7031 -2.37673 +624 2 16.5452 0.8605 8.67269 -3.47063 -2.57745 5.28583 +625 1 6.14624 11.7631 8.37671 0.810232 -55.5778 6.71556 +626 2 5.32447 11.4591 8.84151 13.2611 12.3623 -11.7456 +627 2 6.64226 10.8931 8.20176 -18.8432 36.5086 0.169281 +628 1 2.88754 8.61261 0.453821 16.629 -12.4076 -25.9584 +629 2 2.45212 8.04764 18.3917 -7.9132 30.8844 23.5565 +630 2 2.34875 9.28564 0.895642 -16.9187 -4.58083 -11.1609 +631 1 10.1674 10.4623 6.50123 2.03347 0.962837 -14.0367 +632 2 10.6087 9.69731 6.89122 -0.033473 -1.16532 5.68604 +633 2 10.4694 10.4636 5.56932 -4.02396 0.831062 14.2442 +634 1 6.7142 15.6951 6.55167 21.2433 7.58031 13.0519 +635 2 7.14328 16.1838 7.27089 -7.64643 -7.38759 2.93585 +636 2 7.21237 16.006 5.79102 -10.2318 7.90387 -13.7372 +637 1 6.445 13.1807 5.57797 -4.95716 -23.6388 -1.26087 +638 2 6.7301 13.9465 6.07331 -1.77634 9.04977 6.94523 +639 2 6.09943 12.5433 6.22286 1.34041 6.33507 -0.553394 +640 1 16.8242 12.5629 9.83758 4.06472 -20.7324 4.78658 +641 2 16.9985 11.8651 9.16533 -5.27225 15.8277 3.76725 +642 2 16.5644 13.3844 9.42716 1.03985 5.07871 -11.9 +643 1 6.03738 2.95058 2.86354 -7.03855 -25.5492 -1.19629 +644 2 6.40977 3.757 2.57075 15.9289 34.7492 -4.17594 +645 2 5.57703 2.61747 2.09059 -4.9021 -9.32473 -6.53819 +646 1 10.9114 3.33767 3.30112 5.22699 -4.50477 6.26496 +647 2 10.297 4.02722 3.58926 -1.95634 -6.20434 -4.73409 +648 2 10.5127 2.84524 2.57795 -5.80356 2.60284 -4.41077 +ITEM: TIMESTEP +10 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.68613 7.08001 17.9478 -7.01358 -5.91592 2.73538 +2 2 7.77987 6.83016 18.2266 16.0785 4.58355 -9.56375 +3 2 8.81561 6.77572 17.042 -2.60158 -2.67368 4.89818 +4 1 18.5411 8.25019 6.8397 -3.31911 20.0829 53.2463 +5 2 0.132112 7.95881 5.98338 15.0803 -17.7916 -37.9407 +6 2 0.419079 7.77779 7.52768 -3.57438 0.834533 -17.4022 +7 1 8.38502 18.5543 6.8162 17.8503 9.74549 -0.663478 +8 2 9.33656 0.12202 6.71165 -15.3958 -3.25669 1.14423 +9 2 7.91896 0.595612 6.31609 0.0971505 0.0480551 2.20998 +10 1 6.59239 1.84347 11.7106 33.6248 -3.3918 -11.5419 +11 2 5.88602 2.36507 12.0365 -24.0057 14.4643 13.3031 +12 2 6.19621 1.03555 11.4016 -9.54455 -15.1367 -3.43817 +13 1 7.13469 5.75647 2.33282 -16.0707 1.2807 18.6339 +14 2 6.47472 6.10605 3.02238 22.3175 -2.25238 -34.2201 +15 2 7.09016 6.23688 1.47486 -10.0175 -2.52095 21.7818 +16 1 16.2156 10.1493 16.1334 -27.9935 4.46583 14.8083 +17 2 17.0011 10.2168 15.6173 19.2784 7.57164 -10.1711 +18 2 15.8457 11.0427 16.2776 9.29404 -6.61316 -4.9073 +19 1 10.6069 15.0238 2.30809 -6.31705 -20.7544 -7.43742 +20 2 10.5597 14.4327 3.07214 -0.102442 0.508968 4.74876 +21 2 11.0526 15.7982 2.62807 10.1844 15.1967 6.36644 +22 1 17.1594 8.2489 10.3903 7.52685 0.546464 5.9579 +23 2 16.5819 8.79937 10.9325 -0.0424193 4.91704 3.34034 +24 2 17.9857 8.74574 10.257 -6.36369 -4.03495 0.916497 +25 1 14.8922 15.8683 16.3299 23.5339 -10.8154 7.03311 +26 2 14.0097 16.1903 16.2206 -28.4756 7.26009 1.81472 +27 2 14.9055 15.3621 17.1614 -4.45807 1.9077 -0.883551 +28 1 12.1657 13.3863 0.41518 7.67499 -13.0963 13.9948 +29 2 12.1102 13.7181 18.1579 -7.06431 5.66946 -3.72811 +30 2 11.6673 13.9211 1.04936 -4.85696 8.50836 -7.81927 +31 1 9.27628 5.36844 4.05123 -34.192 4.59602 9.65195 +32 2 8.65917 5.24858 4.84371 24.3198 3.71877 -28.2857 +33 2 8.65376 5.51218 3.29446 11.8948 -3.58803 14.2972 +34 1 1.82985 4.27304 11.6494 -12.5424 24.0017 -6.14821 +35 2 1.72713 5.22025 11.9335 1.67264 -20.3932 -8.37626 +36 2 2.38183 3.84857 12.2925 10.2742 -10.1374 14.5925 +37 1 1.96666 6.8371 8.3675 -1.07206 -9.37897 -7.64517 +38 2 2.48137 7.16021 9.09528 7.6819 14.0614 11.7347 +39 2 1.91994 5.89719 8.57067 -2.65468 -6.85216 -5.3032 +40 1 5.40566 4.39875 7.93795 -15.0212 -10.7202 -17.6012 +41 2 5.47911 3.43644 7.82861 5.00513 7.47325 10.3929 +42 2 4.74947 4.60653 7.2496 8.53973 6.88839 10.8311 +43 1 3.24286 2.9209 17.5475 -3.50993 31.6723 15.8788 +44 2 3.91538 3.33593 16.9792 1.14815 -4.85754 -1.50754 +45 2 2.90196 3.68515 18.1088 4.46159 -27.603 -16.229 +46 1 7.46543 5.27113 6.11173 -0.267366 -14.8618 42.036 +47 2 7.89952 5.61794 6.92737 -2.28349 10.3868 -28.0837 +48 2 7.00366 4.5014 6.50229 0.780861 12.0869 -17.1147 +49 1 9.7753 7.01959 11.9799 12.4421 -0.327694 33.7281 +50 2 10.3285 6.37932 11.5448 5.34489 -7.46932 -11.0014 +51 2 9.14168 7.33293 11.3548 -18.5265 5.10994 -23.2436 +52 1 14.1114 3.54906 8.03925 -21.2079 2.70274 -24.764 +53 2 13.5379 4.24737 7.67406 9.42135 -8.95765 0.532077 +54 2 14.4057 3.90023 8.85862 11.8721 11.0917 26.6467 +55 1 4.80077 17.263 4.02669 -14.2573 4.92943 -10.2324 +56 2 5.55275 17.8868 4.11075 -15.7048 -9.31229 -6.31173 +57 2 4.21849 17.485 3.25536 16.798 3.03083 13.1086 +58 1 16.5008 16.6241 10.052 9.35033 0.377019 -20.0251 +59 2 16.0742 16.3966 10.8515 -13.0635 -0.25069 32.9814 +60 2 15.9476 16.1716 9.40786 2.84148 0.00630379 -7.36632 +61 1 1.95698 4.92664 0.48601 10.6785 6.17321 -0.923017 +62 2 2.54546 5.28332 1.19783 -10.1544 -3.94981 -19.1082 +63 2 1.86706 5.64777 18.4726 -0.259245 -4.73099 10.3692 +64 1 11.8035 13.3621 16.2801 -12.0315 -31.2076 -16.8087 +65 2 11.3006 12.5351 16.4295 -1.37085 13.2186 10.8936 +66 2 12.2283 13.1244 15.4353 5.36339 15.8055 8.10642 +67 1 10.1086 11.0623 16.95 16.2363 -23.6439 1.11167 +68 2 10.572 10.1938 17.105 -14.3776 22.5927 -6.24497 +69 2 9.21542 10.8357 16.6616 -0.160324 -0.0991661 2.29857 +70 1 11.7231 17.5369 13.4667 -11.0418 -25.624 2.08744 +71 2 12.2825 16.9797 12.896 1.06573 10.1819 1.6514 +72 2 12.0497 18.4302 13.3866 8.679 12.3703 -3.21063 +73 1 6.34404 9.31427 12.2267 -10.7289 -25.2447 -16.4149 +74 2 6.95388 8.98312 11.5319 -2.39052 10.1346 10.7157 +75 2 6.76108 10.0063 12.722 17.2241 14.9443 4.4156 +76 1 16.2191 12.7237 2.7003 -6.42998 -13.8373 4.3175 +77 2 16.9936 13.1939 2.44509 26.0904 7.71252 -7.79508 +78 2 15.5637 13.4111 2.72948 -20.2851 11.8065 3.04981 +79 1 0.635855 12.5646 5.86231 -29.6975 10.9384 -12.0161 +80 2 0.906184 12.4779 4.92975 2.15237 -1.21985 12.1118 +81 2 18.3245 12.8391 5.75844 29.6273 -11.2198 7.31028 +82 1 5.19222 16.3868 18.4948 24.5889 -0.529385 -6.85369 +83 2 5.88953 15.8781 18.0466 -13.534 -2.69513 -2.10794 +84 2 5.71609 16.8872 0.480999 -10.5805 4.6302 6.45748 +85 1 0.515864 7.62939 4.0653 41.0474 19.9956 -23.6294 +86 2 18.5677 8.05158 3.40199 9.2753 -7.28591 11.0746 +87 2 1.47269 7.84683 3.73678 -46.4137 -9.00167 19.6367 +88 1 3.14217 8.89553 6.52533 -39.0459 6.50689 -6.5056 +89 2 3.57285 8.63007 7.33767 0.0694837 -1.26665 5.56399 +90 2 2.14756 8.93745 6.67407 38.5311 -3.64433 -0.906695 +91 1 7.31414 10.3036 16.1763 -22.1518 3.21861 21.8391 +92 2 6.53268 10.4772 15.6415 8.43374 -0.0418936 -5.11234 +93 2 6.92709 10.2964 17.0866 13.3044 -2.27208 -10.5118 +94 1 11.1096 1.06093 5.00144 -6.80657 -2.48033 -19.8934 +95 2 11.1672 1.90146 4.5306 6.84499 7.0717 9.43568 +96 2 10.7236 0.515071 4.29558 2.64862 -9.02148 12.7331 +97 1 4.44354 2.70015 13.2121 -7.85281 -5.62302 -11.5877 +98 2 4.59136 3.20795 14.0303 0.103412 -15.4758 0.294405 +99 2 4.3686 1.71349 13.3622 2.85998 26.6352 12.1157 +100 1 8.41457 10.0307 1.78829 1.66015 -12.4273 17.1623 +101 2 8.40835 10.6665 2.53096 -1.47245 -0.417386 -5.09881 +102 2 8.60407 9.1525 2.20287 -3.10051 22.5249 -10.5265 +103 1 10.5229 1.75436 15.5533 -10.8574 -2.31 -4.36647 +104 2 11.4367 1.69676 15.8141 13.1269 -3.82494 7.61076 +105 2 10.5487 1.84704 14.5957 -9.26118 2.80358 -1.94415 +106 1 2.76968 12.9399 7.75003 -7.62511 -10.5749 7.18171 +107 2 3.32023 13.5874 7.29614 -2.30989 2.01815 -3.81018 +108 2 2.03946 12.7099 7.15165 5.79412 3.19458 -2.23462 +109 1 3.64251 11.6901 5.3273 -16.0178 -10.9709 -3.95767 +110 2 3.35804 11.041 6.0007 8.31372 10.277 -11.7948 +111 2 2.86611 11.8409 4.75105 13.6859 -0.281218 5.78901 +112 1 6.88155 14.4797 16.8524 -8.387 2.95998 -0.938339 +113 2 7.57426 13.8507 16.6622 5.60788 -2.76391 3.60002 +114 2 6.54738 14.7428 15.9834 -3.14908 -1.19839 3.78249 +115 1 14.1759 14.5423 3.40785 14.1775 -0.803279 -11.9449 +116 2 13.6583 15.316 3.2037 -5.78511 13.0134 -4.56688 +117 2 13.7723 14.1777 4.18517 -7.95121 -12.1195 11.7606 +118 1 8.26975 18.1784 16.0718 57.0984 -9.85256 5.13508 +119 2 8.90468 17.4721 16.3223 -30.0265 -6.05197 -2.08742 +120 2 8.93252 0.246004 16.0158 -21.102 13.2242 -8.22396 +121 1 4.73201 1.6168 4.90814 8.59128 29.3629 -19.7592 +122 2 3.91099 2.13549 5.04668 12.4977 -9.17326 -4.88478 +123 2 5.26431 2.14928 4.23236 -22.3039 -21.7635 28.9569 +124 1 15.1182 12.8405 16.4381 19.169 -3.61406 36.631 +125 2 14.6612 12.9963 17.2965 -1.87916 -0.605635 -21.6052 +126 2 14.5331 12.7051 15.7087 -30.2626 -2.71441 -16.8094 +127 1 15.786 18.3864 16.793 25.1295 13.8681 33.7963 +128 2 16.4578 18.6099 17.5315 -31.6416 -14.5347 -31.3905 +129 2 15.6162 17.4305 16.8164 1.02724 4.80811 3.46398 +130 1 1.14089 1.13731 16.5539 1.05247 19.7088 19.8175 +131 2 1.92337 1.60495 16.9036 -3.97271 -4.80748 -10.3705 +132 2 0.461096 1.48073 17.164 6.66439 -11.1518 -10.5802 +133 1 18.0862 4.58432 15.8734 11.1688 -12.2484 -2.69667 +134 2 18.5694 3.95442 15.2994 -8.21946 11.4291 8.6944 +135 2 18.5872 4.69164 16.6898 0.203498 -2.64567 -2.95902 +136 1 12.2303 16.9505 16.1288 -38.2728 -13.2591 26.8237 +137 2 11.3888 16.5791 16.5378 36.1694 7.82178 -3.50336 +138 2 11.9114 17.1502 15.2549 6.78701 5.10115 -22.4581 +139 1 15.8814 2.54765 17.9709 5.97775 7.55467 -0.319093 +140 2 15.7733 3.43717 18.3784 -1.8513 -17.3861 -11.5789 +141 2 15.6471 2.5946 17.0126 2.53833 6.86428 19.1803 +142 1 6.70799 13.8021 10.253 -1.58408 1.43394 8.76454 +143 2 6.59288 13.5189 11.1728 1.36627 8.87991 1.27306 +144 2 6.58321 12.9942 9.75946 1.30239 -6.02422 -13.3165 +145 1 10.1413 18.2148 2.80353 9.44086 30.3012 -19.3156 +146 2 10.2266 0.305071 2.14691 0.267733 -14.8877 14.3982 +147 2 9.27777 17.8669 2.60695 -13.096 -6.5965 0.845742 +148 1 2.97176 17.7529 6.06326 -6.30899 -0.645097 35.0899 +149 2 2.08427 17.6133 5.69483 9.57331 2.68214 -12.771 +150 2 3.63239 17.8017 5.37586 1.28926 -2.69105 -18.2517 +151 1 12.5668 16.9974 7.96757 -20.2971 -18.5655 21.3419 +152 2 11.8856 16.2971 7.95074 9.26888 3.31932 -10.856 +153 2 12.3344 17.4798 8.78306 11.437 7.92329 -7.28752 +154 1 14.8861 15.2795 8.28974 -15.7554 0.3814 10.2226 +155 2 14.0374 15.7294 8.25106 -5.80199 2.88483 11.5438 +156 2 15.1981 15.4683 7.42207 26.2963 -2.4275 -26.3232 +157 1 17.5473 18.3112 0.374559 -18.2134 -6.45531 -4.6775 +158 2 18.2634 17.761 0.12213 22.8374 -25.4457 -15.3465 +159 2 17.9951 0.303427 0.894204 5.3706 29.2695 18.8411 +160 1 0.910079 10.3754 1.4141 -19.386 -45.7403 28.0244 +161 2 0.0926857 9.86966 1.69283 27.9138 11.9581 -5.7438 +162 2 0.554372 11.07 0.90565 -10.4877 37.4892 -28.5805 +163 1 1.56425 12.1843 3.32385 10.4497 17.8757 14.7846 +164 2 1.39557 11.5297 2.67534 -6.58566 -33.3087 -13.0061 +165 2 1.62643 12.9551 2.76927 3.66066 18.4363 0.784965 +166 1 0.55148 17.2559 4.87768 14.7947 16.704 -22.83 +167 2 -0.0171494 17.9122 5.24737 -12.9669 22.3753 -0.718336 +168 2 0.416337 16.5086 5.40997 -1.38762 -39.6682 22.4532 +169 1 1.10468 1.00284 9.3945 22.843 10.0615 -6.85845 +170 2 1.39907 0.698807 10.2625 -7.65597 -6.79115 6.92044 +171 2 0.213465 0.701839 9.27091 -15.6194 -8.53979 4.03703 +172 1 16.7947 2.33154 13.2859 2.87858 8.18604 -25.1476 +173 2 17.0129 2.55787 12.3417 -6.42954 -5.0835 25.2497 +174 2 16.4749 1.41822 13.3005 0.0523867 -3.46078 1.59731 +175 1 2.46566 15.827 12.1934 26.7468 -10.5365 13.2985 +176 2 2.93451 15.5288 13.0073 -9.90545 6.65681 -19.023 +177 2 2.95128 15.4495 11.4346 -3.9234 5.36807 1.6728 +178 1 16.4371 15.5461 5.94503 -4.66267 19.6238 -8.97399 +179 2 17.3612 15.5093 6.28134 -9.63254 6.93473 -7.38316 +180 2 16.3109 16.2991 5.29174 10.2179 -16.1602 20.4085 +181 1 5.84392 5.02209 11.7979 1.85982 -4.44524 -6.98506 +182 2 5.51366 5.87933 12.041 -2.35542 15.5447 8.97079 +183 2 5.10963 4.44446 12.0068 -1.26359 -10.5886 0.396425 +184 1 15.2223 4.8645 0.724291 -23.0156 -11.391 23.7803 +185 2 14.7624 4.52384 1.55825 21.1304 12.2284 -22.5635 +186 2 14.5125 5.05103 18.7394 0.751055 2.39009 4.23042 +187 1 16.343 16.2984 2.11648 10.3227 5.9227 -27.7144 +188 2 16.0112 16.8052 2.83865 -11.2354 10.0489 28.078 +189 2 16.6417 17.0002 1.51324 -1.84363 -9.29214 0.277829 +190 1 0.300695 4.8777 3.79796 -11.7144 38.8206 3.66766 +191 2 0.319109 5.88664 3.94702 6.24107 -45.2605 -6.61048 +192 2 1.15751 4.50056 4.01017 2.49534 2.82459 2.96224 +193 1 2.92353 14.9884 15.0405 10.7548 -7.33568 16.7257 +194 2 2.98085 14.609 15.9661 -8.47597 15.0336 -19.5599 +195 2 2.47925 15.8529 15.1074 -0.728265 -0.613609 8.13891 +196 1 1.11951 14.5697 9.5576 17.0302 46.4745 -20.2694 +197 2 2.08903 14.5584 9.38425 -20.4257 -12.3501 8.75388 +198 2 0.805573 13.7616 9.91809 5.52927 -28.6811 10.8766 +199 1 13.6617 16.6633 11.5459 -10.7506 10.3565 -21.4971 +200 2 13.3218 17.4276 11.0158 5.92664 -14.8533 17.3679 +201 2 13.3915 15.8986 11.0154 -3.11899 -0.859159 7.39997 +202 1 4.73366 1.47986 0.719369 -25.3145 -4.02421 3.51446 +203 2 4.15092 1.98399 0.125941 8.58395 1.79335 0.854136 +204 2 4.09918 0.853913 1.13528 12.7275 2.9151 -0.0185569 +205 1 1.42442 18.4742 11.9045 -6.93945 20.4545 -13.991 +206 2 1.2372 0.390371 12.6666 -0.822965 2.19478 3.53324 +207 2 1.89543 17.725 12.2367 7.95706 -17.4489 5.30436 +208 1 11.5469 10.1058 4.11116 26.1716 14.4711 -26.2735 +209 2 11.5284 10.5631 3.21886 -3.69376 -13.1884 23.9867 +210 2 12.5118 10.0773 4.36205 -26.1062 -0.534026 -7.20275 +211 1 8.37237 12.1712 3.75254 -13.3709 24.5961 46.1376 +212 2 9.17249 12.5936 4.11701 3.41223 -8.92861 -19.033 +213 2 7.75234 12.4533 4.48752 5.20668 -18.7884 -32.053 +214 1 14.3233 4.03204 3.29282 11.0049 6.10018 19.4579 +215 2 14.9517 4.19348 4.04461 -8.72763 -4.53117 -18.7735 +216 2 13.4979 4.46304 3.56838 3.12416 -1.49393 -3.31976 +217 1 5.58139 1.77074 7.50691 -36.613 -47.7339 30.604 +218 2 4.96189 1.1025 8.02564 35.7201 38.4984 -27.3817 +219 2 5.38779 1.57566 6.57729 1.13697 3.96791 -6.02851 +220 1 17.9042 1.1171 4.88471 6.84957 17.1887 -7.45832 +221 2 18.4571 1.56865 4.21188 -4.6905 -14.0516 5.22121 +222 2 17.737 1.81424 5.53024 -1.96776 -6.02251 3.4729 +223 1 6.82733 9.39684 4.48845 1.87187 -0.890058 -10.0607 +224 2 6.84716 9.53076 5.42818 -7.08772 5.76802 18.8049 +225 2 7.72364 9.08838 4.32443 4.93667 -1.85919 -9.57362 +226 1 2.70107 14.964 1.9632 9.79064 -8.50271 -23.1477 +227 2 3.33865 14.7342 2.63816 0.0868029 -0.794049 11.9475 +228 2 3.17782 14.7454 1.13419 -13.4 8.87294 12.5953 +229 1 17.2782 12.8964 13.1387 8.1593 -36.3772 6.82198 +230 2 16.3556 13.1177 13.3173 4.03584 18.7537 -2.31465 +231 2 17.8303 13.6552 12.9439 -8.38561 20.0322 -1.78655 +232 1 15.018 10.5797 1.38541 -30.6488 -33.8734 -22.7761 +233 2 15.5405 11.2097 1.82354 25.6355 33.1541 21.1587 +234 2 14.2986 11.0703 0.97193 1.92599 -0.723232 4.24038 +235 1 5.71261 6.94641 4.5266 2.6516 -23.4686 10.5302 +236 2 5.87991 7.88124 4.41392 4.1014 10.4162 -0.896017 +237 2 6.40034 6.62744 5.14459 -6.91809 0.316355 -6.72793 +238 1 8.10894 8.26231 10.1757 -1.61977 4.99166 17.0229 +239 2 8.63366 8.87039 9.65704 12.8257 12.1371 2.09156 +240 2 7.5873 7.82886 9.51802 -16.026 -14.2044 -11.4362 +241 1 13.5265 18.2929 5.80397 -22.7677 -1.43199 15.791 +242 2 12.744 0.210577 5.63003 6.52185 -0.137688 -2.34328 +243 2 13.224 17.7307 6.55929 8.82644 11.7072 -16.2211 +244 1 0.31998 2.55606 0.111337 -23.7151 48.4906 1.53453 +245 2 18.006 2.70756 18.6319 7.21623 -15.3908 0.76394 +246 2 0.639493 3.49242 0.214062 7.71863 -30.3236 1.31164 +247 1 12.6438 10.9651 9.76843 -27.6007 42.776 -15.0826 +248 2 11.6462 10.8587 9.68427 36.5826 -6.8361 3.61513 +249 2 13.0097 10.1328 10.024 -0.792921 -29.0746 6.76076 +250 1 0.78357 12.2825 11.0843 20.7577 -6.91251 -2.74458 +251 2 18.4749 12.2741 11.1385 -12.0685 2.84404 7.0736 +252 2 1.15918 12.6384 11.9096 -11.1326 -3.84191 -3.75479 +253 1 5.04379 7.22322 13.4829 1.39832 5.89977 -6.97466 +254 2 5.58123 7.93479 13.1271 0.448534 7.96016 -10.0051 +255 2 5.53384 7.00565 14.2746 1.03136 -7.66768 11.7435 +256 1 1.27874 6.97532 11.834 -32.074 -43.2189 -14.0481 +257 2 0.482678 7.18669 11.3131 10.1443 0.561183 6.98996 +258 2 1.70367 7.78255 12.0103 18.1825 36.8435 9.31001 +259 1 15.4541 9.47267 12.3132 5.88964 23.7827 6.22024 +260 2 15.5166 10.4677 12.3686 -5.40153 -30.7713 4.20372 +261 2 15.4815 9.07432 13.2056 -1.6395 12.2138 -11.1334 +262 1 16.6425 12.9485 5.45228 -24.7761 13.2233 -32.5849 +263 2 16.3124 13.8685 5.42836 11.1894 -7.98651 20.9726 +264 2 16.4187 12.7313 4.52305 11.1313 -16.3356 15.5726 +265 1 6.1733 10.0557 0.193027 -12.4899 -11.5053 -32.3049 +266 2 5.38495 10.4604 0.58061 6.43577 -0.470902 4.897 +267 2 6.88008 10.1049 0.827544 12.5305 3.42311 14.2724 +268 1 12.3659 6.05415 4.04188 -22.1763 -21.8278 15.5685 +269 2 12.3683 6.79715 3.46108 4.13216 24.0909 -16.7914 +270 2 11.421 5.79287 4.05326 15.4186 -0.211849 3.77561 +271 1 0.132582 12.8231 0.203992 -0.195483 1.63508 -4.90635 +272 2 -0.0245094 13.5503 0.825031 2.49545 -1.98409 0.771993 +273 2 18.2458 13.055 18.0666 5.13636 -1.5464 3.82803 +274 1 3.83888 18.5816 8.61379 -9.81831 -4.88162 -16.6552 +275 2 3.52001 18.2631 7.75085 8.43173 -4.7192 1.01067 +276 2 3.03206 0.305129 8.96677 -7.80256 7.43459 9.99927 +277 1 7.39556 17.2738 4.45596 16.9172 12.0122 12.5371 +278 2 7.99849 17.9848 4.79149 -15.6229 -16.9846 -19.2965 +279 2 7.33818 17.3251 3.48629 6.36463 5.57381 8.87833 +280 1 9.21998 17.0388 12.2284 15.8258 3.83046 11.207 +281 2 9.35195 16.1931 11.7423 2.16771 12.8413 7.7779 +282 2 10.0104 17.2216 12.8137 -16.5375 -11.854 -19.0408 +283 1 13.3184 13.0063 7.94019 -19.3301 -32.807 5.85066 +284 2 13.1883 12.2647 8.56801 -4.60418 3.91603 -7.64254 +285 2 14.1459 13.3708 8.19821 21.3317 21.1541 5.11013 +286 1 14.9844 2.95035 15.3504 8.07249 -1.73557 -24.8008 +287 2 14.3 2.40675 14.9389 -0.805511 -1.63288 7.60525 +288 2 15.6705 2.98762 14.6436 -9.05507 2.69068 16.8604 +289 1 9.85476 15.5033 17.004 5.70996 8.22456 -10.0233 +290 2 10.2769 14.6753 16.7296 0.407564 1.12786 2.5917 +291 2 9.2992 15.3275 17.7693 -4.49302 -4.18434 5.79618 +292 1 11.2887 8.25054 16.5462 4.3815 15.8935 1.4126 +293 2 10.7498 7.72178 15.9677 -11.4268 -3.01506 -11.0903 +294 2 11.7109 7.60541 17.1026 7.03572 -6.39426 11.2088 +295 1 3.78312 18.1923 16.7229 -8.20319 16.8802 -14.09 +296 2 4.23544 17.5706 17.2928 8.99584 -2.65396 14.876 +297 2 3.78517 0.451969 17.0887 5.65759 -16.2586 2.71634 +298 1 2.1977 4.10819 8.95021 24.5715 -13.8141 31.6135 +299 2 3.03624 3.61916 8.82088 -15.7399 12.2693 -11.2697 +300 2 2.14197 4.07166 9.94067 -11.3718 7.67499 -23.2123 +301 1 9.90974 10.3516 9.73776 -22.8793 37.5197 3.40937 +302 2 9.44348 11.1923 9.4561 16.1923 -27.4723 -0.755713 +303 2 9.93951 10.4177 10.7077 4.76489 -7.47333 -8.73237 +304 1 9.73601 0.810068 10.8572 -6.50885 -0.835519 -1.39877 +305 2 9.40585 18.6129 11.1735 2.22486 -11.7661 13.7712 +306 2 9.0915 1.01857 10.1847 -1.93261 14.5334 -11.6688 +307 1 9.19364 15.2092 10.2107 -23.0073 -10.2994 -8.74256 +308 2 8.9841 16.0542 9.76587 1.98806 -14.8547 5.4661 +309 2 8.35152 14.6762 10.1166 22.3916 12.2872 5.93767 +310 1 0.995532 9.29186 10.3281 47.9462 -2.63812 -8.64675 +311 2 1.22741 10.2031 10.5086 -13.3799 15.5027 2.96196 +312 2 1.9063 8.9262 10.1621 -35.7029 0.949407 3.82346 +313 1 16.813 4.88766 8.1932 11.5161 -10.5322 32.9144 +314 2 16.1615 5.34773 8.77307 11.8935 -6.11126 -18.0819 +315 2 17.4051 4.37395 8.80041 -19.6267 13.8505 -17.9411 +316 1 14.6429 14.6942 0.394535 -7.00543 -1.89626 8.24203 +317 2 15.0463 15.2494 1.09531 -2.64327 -9.316 -7.76003 +318 2 13.8679 14.2346 0.794348 15.878 11.3494 -8.58286 +319 1 3.51953 11.0524 9.63262 1.11689 7.20138 -8.56155 +320 2 3.49309 11.4422 10.5196 2.01858 0.130954 -3.30783 +321 2 3.17116 11.7397 9.0203 2.67149 -7.88535 6.47818 +322 1 11.039 10.8616 1.27104 8.39953 16.0658 -8.46941 +323 2 11.1885 11.6907 0.750788 0.782166 -19.893 14.3131 +324 2 10.1072 10.6419 1.14889 -0.773464 -1.49716 1.06219 +325 1 13.2204 7.07184 12.8933 -24.0174 5.01566 -6.09093 +326 2 14.1394 6.83939 12.9167 20.0602 -3.76028 0.39046 +327 2 12.7464 6.22555 12.8749 2.49778 2.97258 -0.29329 +328 1 9.62856 1.88969 0.946546 9.2636 -0.931103 20.1878 +329 2 8.76541 2.02695 0.593353 -22.3319 -0.80038 -4.92587 +330 2 10.1675 1.74594 0.181071 13.2226 0.132969 -11.6901 +331 1 10.5934 13.5316 4.73807 16.1446 0.574492 13.3086 +332 2 11.4317 13.0614 4.94174 -10.7106 3.3069 -14.0299 +333 2 10.5321 14.1207 5.51129 -4.24994 -4.20037 -10.3127 +334 1 14.2715 1.70318 10.8964 -1.77809 5.91235 7.28652 +335 2 15.0728 1.25501 10.5853 5.24738 9.35157 -1.74174 +336 2 14.4034 2.67095 10.8772 7.32957 -6.49183 -2.39775 +337 1 14.6603 12.4192 11.7243 1.91159 -25.2344 -56.6412 +338 2 15.4845 12.4874 11.1931 -4.23005 7.1619 22.5795 +339 2 14.0903 12.0081 11.0211 -1.48986 11.1607 31.5891 +340 1 8.24886 5.08654 9.79134 -29.2123 3.64284 23.7692 +341 2 7.42109 5.02927 10.3149 15.0309 17.1198 -4.03621 +342 2 8.23121 4.21184 9.43797 12.1669 -22.8524 -17.3047 +343 1 1.59528 16.8201 18.3251 -4.66834 32.7155 -7.23976 +344 2 1.93304 17.2062 17.488 -5.12416 -8.69561 13.5025 +345 2 1.82608 15.9028 18.3034 8.21551 -19.1337 -3.40609 +346 1 1.44054 17.2474 15.3375 38.2305 -7.16391 -6.50211 +347 2 1.35107 18.1379 15.6308 4.79859 24.8425 9.12518 +348 2 0.562777 16.9452 15.3387 -39.5261 -18.284 -3.02502 +349 1 3.72855 5.57524 6.20331 -9.94128 10.6794 2.05156 +350 2 3.21297 6.20603 6.76334 9.83918 -6.42931 -13.7589 +351 2 4.29894 6.06824 5.5848 -3.89827 7.08279 4.15512 +352 1 12.3545 9.42683 14.1827 20.4014 -41.9092 8.4814 +353 2 12.8623 8.59837 13.88 -21.4785 35.8512 3.66034 +354 2 12.0611 9.1345 15.077 2.36507 11.6403 -12.9904 +355 1 4.03327 15.2744 6.905 24.5442 3.45717 -5.69457 +356 2 3.46314 16.0225 6.67296 5.01039 2.15408 -3.12402 +357 2 4.97164 15.5268 6.67147 -27.9532 -4.4537 7.17357 +358 1 0.606997 8.56433 14.8637 1.00605 -0.185347 4.59471 +359 2 0.51054 9.52697 15.0006 4.18475 -5.95105 -3.81642 +360 2 1.25745 8.45601 14.1476 -5.10421 5.72757 5.73964 +361 1 12.9756 8.36618 10.3398 20.3701 -17.1189 -10.5242 +362 2 13.727 7.8435 10.0036 -6.14808 8.99881 -11.6124 +363 2 12.9675 8.02293 11.2263 -11.3517 2.56625 21.5008 +364 1 15.2884 7.63693 3.49378 10.1588 18.7913 -12.1111 +365 2 14.5458 7.1482 3.08376 7.93209 -0.245397 21.6039 +366 2 15.5211 7.50792 4.43838 -15.1505 -14.5868 -6.72816 +367 1 17.3202 6.64717 0.0328861 -29.9623 13.6257 -2.83905 +368 2 16.7745 5.97673 0.482414 9.93705 -0.647346 -3.81794 +369 2 16.6178 7.22121 18.2734 18.8696 -9.84661 9.86066 +370 1 8.80495 6.92785 7.84504 -31.0915 -18.6038 9.28479 +371 2 9.6769 7.2872 7.80779 30.3288 7.87046 2.96903 +372 2 8.72406 6.35246 8.64105 6.6093 9.83872 -10.9319 +373 1 12.3211 0.614363 1.17365 13.0662 -3.77868 -0.487657 +374 2 13.0766 0.983141 1.64654 -0.239842 1.32967 3.5541 +375 2 12.751 18.5673 0.657414 -10.2946 0.778432 -2.83622 +376 1 5.67951 15.1028 14.5131 10.9467 16.6442 -3.65569 +377 2 4.71936 15.1727 14.6088 -3.18386 3.297 0.861488 +378 2 6.03308 15.9436 14.1233 -11.409 -15.106 9.73801 +379 1 3.83531 6.52602 1.68735 -5.34791 11.2881 1.09554 +380 2 3.46655 7.33088 1.27913 5.03876 -12.3281 -3.02901 +381 2 3.83759 6.80671 2.60341 5.67562 -6.55284 8.9174 +382 1 3.89065 11.6139 12.2421 9.17745 -10.34 -2.42323 +383 2 4.7546 12.041 12.3761 -4.43478 1.7756 4.32079 +384 2 3.22616 12.1252 12.7041 -4.55935 10.4369 8.15325 +385 1 5.44913 3.8771 15.872 6.89679 52.3696 13.3559 +386 2 6.00532 3.19945 15.5174 15.3476 -19.3003 -7.67953 +387 2 6.04432 4.69577 15.9682 -27.8341 -34.2187 -5.04159 +388 1 14.46 10.319 4.39654 9.99722 -28.3378 -34.0856 +389 2 14.8446 9.82936 5.13517 -3.65574 0.244774 4.37558 +390 2 14.7053 9.78242 3.56924 -11.9433 24.8074 33.8136 +391 1 7.944 17.2975 9.23787 -28.0002 30.4191 -3.50914 +392 2 7.19679 17.6006 9.79194 10.1387 -11.5361 -1.79961 +393 2 7.93806 17.9436 8.50883 9.12371 -8.84918 -0.989999 +394 1 4.50274 14.4265 3.96251 25.8442 16.5744 44.5421 +395 2 4.82189 15.3364 4.24204 -15.9069 -22.6382 -13.9696 +396 2 4.78076 13.8411 4.72747 -13.1976 12.376 -28.3375 +397 1 14.3227 7.38582 15.7589 14.6846 6.74467 9.8564 +398 2 15.2487 7.24382 15.4614 -20.8339 3.06086 7.28672 +399 2 14.432 7.78597 16.648 -5.3607 -7.66211 -14.83 +400 1 2.87305 18.2228 1.9038 16.9424 31.4889 37.3817 +401 2 2.5254 17.6641 1.24513 -20.0746 -27.9737 -30.7942 +402 2 2.12041 18.5329 2.44243 8.04928 -1.15784 -8.26421 +403 1 7.96513 1.6038 4.534 28.375 12.0389 1.8382 +404 2 7.4881 1.94169 3.78174 -16.4915 0.831655 -6.1583 +405 2 8.81315 2.08427 4.47067 -11.0504 -12.9149 7.37414 +406 1 2.66628 14.1304 17.7551 -36.5802 -20.3813 5.76686 +407 2 1.82799 13.6385 18.0009 26.1666 13.51 -7.41699 +408 2 3.38829 13.5766 18.1016 -3.21353 7.84202 -3.40779 +409 1 0.72398 1.68558 13.861 19.6061 1.62564 -3.20216 +410 2 0.832024 1.51571 14.7895 8.81281 -5.19825 13.648 +411 2 18.448 1.87896 13.7961 -22.7247 6.41229 -8.76432 +412 1 4.5528 18.6039 13.9643 16.282 -5.93943 -10.6264 +413 2 5.43228 18.1791 13.8337 -18.6035 11.3559 2.42201 +414 2 4.30609 18.3878 14.8696 -5.35687 -0.29015 4.72759 +415 1 7.10471 0.475722 18.3652 -9.95344 30.3778 33.8159 +416 2 7.09526 0.10374 17.5021 -2.11792 -9.18089 -28.9852 +417 2 6.24907 0.928295 18.5508 11.5399 -12.8337 -6.73806 +418 1 16.1003 18.4419 14.1295 -36.1288 -26.1963 -8.72431 +419 2 15.3858 17.8107 13.8537 25.0074 20.4613 -2.43664 +420 2 15.9155 18.5409 15.0697 10.6475 8.10349 1.05551 +421 1 10.1087 4.51964 16.2872 -49.6317 2.46368 -20.184 +422 2 10.9899 4.47274 16.5903 35.3659 -6.27505 9.52333 +423 2 9.84839 3.65208 15.9265 12.032 5.89647 9.33422 +424 1 15.84 17.9245 4.41355 -16.3771 8.07859 19.8211 +425 2 16.4973 18.6399 4.5293 -6.75294 -6.64677 -2.2152 +426 2 15.0245 18.216 4.92863 29.2279 -12.5546 -21.8691 +427 1 6.93052 17.3604 13.733 43.7573 11.6301 8.94285 +428 2 7.46287 17.7112 14.5144 -20.3873 -12.0805 -21.5216 +429 2 7.61723 17.2481 13.0216 -16.2109 2.19972 16.1164 +430 1 13.284 6.56612 6.73549 -17.3988 -10.9235 -13.9284 +431 2 14.2147 6.66272 6.66556 31.8926 9.42178 10.838 +432 2 13.0817 6.39483 5.81333 -16.4457 -2.73061 -4.18006 +433 1 7.68008 2.38704 9.18412 -10.173 -8.0052 -21.8631 +434 2 7.24249 2.31281 10.0234 -2.88588 -0.126179 20.3224 +435 2 6.98126 2.1061 8.54708 21.029 6.80491 7.05088 +436 1 15.1532 14.8723 13.6487 -17.4978 4.30428 5.82091 +437 2 15.0143 15.0659 14.5909 6.59258 -1.67926 -7.31154 +438 2 14.3234 15.1254 13.2077 14.4343 -4.04757 1.78875 +439 1 9.30028 8.33456 3.70705 10.2977 -8.98362 5.75949 +440 2 10.1463 8.82212 3.80538 -6.03443 -8.47657 3.00821 +441 2 9.47356 7.38745 3.89392 -0.00834887 14.0135 -2.32863 +442 1 17.6906 13.477 16.4461 19.9282 13.2905 -5.82842 +443 2 16.7369 13.3711 16.3792 -1.87427 5.41308 -4.03884 +444 2 17.9311 14.3351 16.016 -12.453 -14.9372 6.18952 +445 1 5.04349 10.6567 2.59903 16.1191 -13.6813 18.2195 +446 2 5.79495 10.2927 3.12129 -13.5181 3.52014 -12.0414 +447 2 4.57705 11.1773 3.24438 -8.0447 10.2459 5.04269 +448 1 3.70971 8.35842 10.3252 1.44092 -18.6834 3.58878 +449 2 3.85247 9.29033 10.1825 3.16815 17.7869 -8.4001 +450 2 3.85129 8.23256 11.2753 -2.11366 -0.888936 -6.9574 +451 1 16.1019 7.11228 6.32302 5.1556 -18.0856 -12.5793 +452 2 16.7603 7.67894 6.76117 -3.13697 -10.0137 -6.06994 +453 2 16.5199 6.22503 6.17941 -9.70023 19.4355 5.8489 +454 1 15.1873 7.00993 9.1119 -0.598311 32.9952 -33.7165 +455 2 16.0219 7.38603 9.44635 -11.3494 -6.74009 0.758637 +456 2 15.0255 7.54922 8.27157 3.37955 -23.1281 33.9738 +457 1 6.44391 13.1496 12.9059 -4.52757 0.45998 7.29234 +458 2 7.24313 12.6736 13.1625 -0.99472 -4.48021 -2.73775 +459 2 6.29798 13.7908 13.6311 -2.25413 -7.45453 -16.6836 +460 1 12.1229 4.49714 13.069 31.9377 20.6864 19.2416 +461 2 12.2438 4.59516 14.0263 7.18846 6.47209 -3.71556 +462 2 11.355 3.98337 13.0276 -40.2556 -25.9573 -14.351 +463 1 11.341 8.18871 7.85243 -8.78275 4.89867 3.16356 +464 2 12.019 7.65272 7.40248 3.56578 3.50389 11.6767 +465 2 11.6495 8.4222 8.75253 4.0122 -9.00416 -11.7002 +466 1 17.1801 10.777 7.4192 7.36201 -8.80257 6.42916 +467 2 17.8272 10.0453 7.20283 -14.4353 25.3005 -3.23105 +468 2 17.1099 11.4706 6.73084 6.53972 -12.3853 -1.04707 +469 1 5.23123 18.1422 11.0533 -19.2518 -11.1169 -0.556795 +470 2 4.68428 18.0818 11.8689 9.03658 -0.237539 -15.4649 +471 2 4.66385 17.8138 10.3113 13.0077 11.3369 14.9543 +472 1 7.56693 17.6215 1.82415 1.62007 -3.46367 5.28784 +473 2 7.78898 16.8334 1.34681 6.63524 -26.0188 -1.32905 +474 2 7.45125 18.2129 1.09256 -3.64481 20.3372 -5.96154 +475 1 1.86389 12.9287 13.6093 11.2123 10.389 11.461 +476 2 1.60858 12.3493 14.3514 0.368407 5.87334 -8.62616 +477 2 2.19533 13.7617 14.0254 -8.04715 -19.4049 -4.74077 +478 1 9.73211 6.79545 14.8053 -13.3635 29.1677 -1.2594 +479 2 9.95388 5.9401 15.1198 6.74212 -35.5267 16.6171 +480 2 9.99758 6.80472 13.8879 2.87601 5.55808 -10.3757 +481 1 15.2079 4.3816 10.7747 2.87683 -10.6846 -6.34453 +482 2 16.1141 4.09829 10.8354 14.0041 -14.4682 -8.99775 +483 2 15.2413 5.10857 11.3759 -13.982 19.572 13.657 +484 1 11.1943 6.12299 0.161942 7.30858 3.38886 3.78771 +485 2 11.3169 5.17116 0.363074 -11.79 12.5462 -9.55941 +486 2 10.2709 6.35961 18.5708 8.1781 -12.6509 6.67443 +487 1 0.185288 11.3311 15.1365 -30.887 25.32 -22.6423 +488 2 18.3259 11.8316 14.411 15.9364 -20.9841 19.9458 +489 2 18.5436 11.8171 15.9275 6.31494 -1.3813 -2.75882 +490 1 7.07253 9.14554 7.26503 -12.8693 -9.44748 7.54332 +491 2 6.53496 8.39024 7.60511 8.01051 18.2562 -7.56901 +492 2 7.96025 8.78683 7.22728 5.66006 -0.214789 -0.295522 +493 1 18.4466 15.4455 12.3524 0.715601 -5.5542 4.25712 +494 2 0.765537 15.5739 12.2932 -9.35503 -1.07101 -3.81958 +495 2 18.1041 15.6865 11.4834 1.82716 1.84183 -0.0676895 +496 1 16.5728 4.36435 5.2485 -25.4993 -8.29978 29.4912 +497 2 16.6816 3.92322 6.14286 5.98391 16.1522 -30.7717 +498 2 17.375 4.39451 4.72672 17.8313 -3.46111 1.89189 +499 1 17.7791 3.0704 10.7152 16.7916 7.15275 7.98838 +500 2 0.0816242 3.14072 10.966 -13.8603 5.05813 -1.71981 +501 2 17.7027 2.20602 10.3066 -7.17166 -8.4112 -5.21368 +502 1 12.3075 0.0618611 10.1685 -8.15907 17.9474 -0.312818 +503 2 11.3684 0.344551 10.3468 27.9971 -1.27027 -0.956139 +504 2 12.8942 0.865557 10.2681 -22.4015 -23.39 -3.54403 +505 1 10.3613 9.82386 12.3172 12.1455 12.129 19.7304 +506 2 11.1427 9.8808 12.9129 -10.2174 -2.53791 -7.09814 +507 2 10.1997 8.88396 12.252 -0.966331 -12.4705 -0.927319 +508 1 0.481536 2.83002 7.02126 3.70324 23.8076 -10.0458 +509 2 0.770856 3.62826 7.51109 -3.83076 -19.2444 -0.666321 +510 2 0.694466 2.06428 7.55035 5.7415 -3.83046 10.8422 +511 1 0.467049 15.2425 6.91705 -4.45928 -38.0226 -11.2702 +512 2 0.600151 15.6263 7.78281 2.30728 -6.41275 13.0317 +513 2 0.61271 14.2361 7.00049 -2.84554 47.7716 -5.16909 +514 1 16.9541 7.01237 15.3291 23.6374 -7.48971 -3.1828 +515 2 17.7457 7.53254 15.1705 -1.99719 18.034 -6.10418 +516 2 17.38 6.19105 15.5941 -13.3003 -10.4743 0.120416 +517 1 9.01017 12.4224 8.1441 -46.2717 9.6088 -11.1501 +518 2 9.26268 11.8248 7.45061 25.2615 -14.9445 -10.6927 +519 2 8.05034 12.5239 7.91838 26.5695 6.53823 20.3475 +520 1 1.26455 1.94093 3.05316 3.58571 9.71968 -12.011 +521 2 1.22461 2.59742 2.34045 -8.12686 -11.986 1.71554 +522 2 1.93366 2.31359 3.63129 0.35358 -2.72116 4.87465 +523 1 4.13309 15.1146 9.63821 -4.623 1.46382 -0.938733 +524 2 4.12694 15.148 8.67475 -7.89004 5.45838 -0.100118 +525 2 4.98588 14.7259 9.81048 11.3537 -4.87926 10.963 +526 1 7.17766 2.17952 14.5652 7.62536 9.73749 11.0593 +527 2 6.96972 1.69872 13.7643 -0.327528 -0.451328 -7.35604 +528 2 7.66158 2.98182 14.3072 -3.86315 -8.18785 -0.50787 +529 1 18.6094 14.7115 2.1553 18.1066 -29.4746 -3.14947 +530 2 0.852094 15.108 2.23259 -6.38197 3.09186 -0.259441 +531 2 17.9366 15.3527 2.32074 -15.2526 23.2774 3.26778 +532 1 9.94663 2.7868 12.9455 2.69617 -13.1789 -11.1834 +533 2 9.77369 2.19316 12.1903 7.43131 1.21406 6.14773 +534 2 9.20096 3.38667 12.9408 -6.30409 9.38042 4.37845 +535 1 2.80852 8.91644 13.0153 -16.8956 -9.28674 -0.0207487 +536 2 3.13809 9.78934 12.8448 9.36486 20.7895 -4.33486 +537 2 3.52774 8.43066 13.407 13.2058 -10.3846 6.75792 +538 1 3.23128 8.35577 3.63883 6.10249 8.71431 60.2633 +539 2 3.54401 9.08838 3.13137 7.96401 15.5303 -21.3649 +540 2 3.46232 8.64756 4.58519 -13.4978 -19.9669 -35.5279 +541 1 5.63324 7.19832 8.5125 -13.133 -10.0414 6.96154 +542 2 5.51092 6.25688 8.34615 12.8941 -5.44374 -4.51219 +543 2 4.92213 7.36133 9.14092 2.83191 13.4678 4.26874 +544 1 14.878 1.27944 2.0109 -7.35803 -30.2596 -13.1701 +545 2 14.8616 1.98275 2.64555 4.54601 24.3613 2.83628 +546 2 15.264 1.50064 1.14913 0.22226 12.7122 6.62367 +547 1 8.2353 15.1956 0.84899 9.2054 13.6294 -15.3468 +548 2 9.04355 15.0937 1.38227 -7.5254 -5.87742 4.76726 +549 2 7.50355 14.6763 1.20804 4.58246 -4.32042 7.88142 +550 1 15.6328 1.34461 7.23795 -19.9173 -11.1245 -9.46976 +551 2 14.9591 0.718796 6.85982 16.5955 19.1651 8.9454 +552 2 15.1508 2.16575 7.45752 1.02199 -7.71962 -3.30529 +553 1 4.91374 13.0908 18.526 15.2565 -4.60213 14.3208 +554 2 5.33439 13.1154 0.77269 -6.07604 1.59812 -16.6926 +555 2 5.51105 13.5936 17.9543 2.83588 -2.74206 0.160853 +556 1 15.3493 8.4742 18.1502 12.1518 9.73195 -18.1744 +557 2 15.7592 9.1135 17.5088 -10.0207 -13.011 16.7995 +558 2 15.2243 8.95162 0.336167 -0.033387 6.18709 -0.40176 +559 1 12.0721 3.03363 18.372 7.89134 -10.3745 2.1206 +560 2 12.0185 2.56449 0.551271 -8.88822 8.03447 17.3967 +561 2 12.5632 2.36483 17.898 4.02516 4.57474 -24.0136 +562 1 13.2076 12.6757 5.17908 4.47921 -5.37266 1.03993 +563 2 13.7293 11.9632 4.79272 -2.12471 -1.88137 -7.76598 +564 2 13.3867 12.5644 6.11349 -3.52883 8.17381 9.78336 +565 1 6.04737 7.04753 0.0353989 10.049 -23.447 -5.31085 +566 2 6.01346 7.99319 18.6275 -7.37118 27.2698 7.20756 +567 2 5.32085 6.74358 0.593628 -6.10646 3.40609 1.47388 +568 1 17.7373 16.0235 15.0083 12.9173 -11.5355 46.7271 +569 2 16.9426 16.5159 15.2406 -3.68569 -0.0523083 -17.9381 +570 2 17.9142 15.8937 14.0864 -12.7219 4.58342 -31.2732 +571 1 13.1912 1.0014 16.5506 10.6966 -14.1722 10.2872 +572 2 14.1553 0.911674 16.6931 -11.9901 3.10273 -3.01829 +573 2 12.8874 0.074803 16.5753 -2.30324 8.04411 -4.14072 +574 1 11.1133 14.5665 7.20897 13.0955 23.3619 -16.6223 +575 2 10.3963 14.2935 7.74934 -21.4591 -15.3449 18.7975 +576 2 11.8402 13.9563 7.34501 4.8973 -5.05394 6.63835 +577 1 17.5096 8.63113 2.08657 0.966478 12.3426 12.6691 +578 2 16.6632 8.50317 2.50987 -10.5053 2.55961 10.3047 +579 2 17.5113 7.91267 1.47949 7.23292 -21.4893 -25.4513 +580 1 12.353 7.99884 2.01581 -2.70101 10.6364 -12.6504 +581 2 12.1945 8.88312 1.63494 1.68617 -6.44935 12.5501 +582 2 11.9639 7.41552 1.35659 -1.58766 -9.18843 -2.08326 +583 1 11.8879 14.6194 10.3406 -20.0746 -33.6598 -22.8547 +584 2 12.0361 13.784 9.8263 4.17148 28.2224 18.5196 +585 2 10.9018 14.6878 10.3309 21.6541 8.7111 3.83339 +586 1 6.88836 7.04362 15.6058 16.1194 20.5136 16.4981 +587 2 7.8035 7.27617 15.3369 -14.4637 -10.2261 -3.41305 +588 2 6.75267 7.59066 16.4113 -4.12685 -13.7627 -18.0291 +589 1 8.00073 4.72844 13.473 32.6072 13.4681 12.0072 +590 2 7.24466 4.78195 12.9199 -26.1194 -0.34176 -19.7698 +591 2 8.43099 5.60279 13.3668 -6.56701 -17.694 4.3215 +592 1 13.409 12.181 14.2619 -2.29334 -12.519 -3.59046 +593 2 13.0674 11.2691 14.1939 2.47622 3.528 5.79283 +594 2 13.8091 12.3245 13.3914 2.14013 7.29019 1.49174 +595 1 14.8335 9.42126 7.30208 -1.23415 -9.7028 -7.755 +596 2 15.6553 9.87909 7.43544 15.0677 5.06613 0.278043 +597 2 14.1895 10.0298 7.62302 -19.0881 6.3544 7.09879 +598 1 12.6523 17.0615 3.07749 -9.63712 20.8437 4.73829 +599 2 12.9489 17.4748 3.92954 -9.59054 -7.90452 -22.4084 +600 2 12.0211 17.6908 2.6147 24.5964 -20.1603 22.3384 +601 1 1.16316 7.14216 17.4575 -7.53687 9.98877 -12.7143 +602 2 0.304551 7.18474 17.9202 3.89796 -5.88799 -6.19513 +603 2 1.03245 7.53978 16.5617 1.30151 -5.77621 16.2427 +604 1 12.7701 5.15004 15.6505 19.6392 -10.8067 9.95473 +605 2 13.4563 4.50157 15.9538 -13.2351 19.2956 -11.0391 +606 2 13.2014 6.03319 15.6187 -0.0564141 -13.897 1.41482 +607 1 2.5292 3.39223 4.98971 -11.294 24.8894 43.5462 +608 2 1.79321 3.13497 5.63732 25.431 9.26734 -19.6171 +609 2 2.95221 4.24201 5.36402 -18.0427 -37.3772 -14.0443 +610 1 8.3195 11.2975 13.4498 34.4282 -42.0873 60.0692 +611 2 8.53145 10.9623 14.3727 -32.5783 27.093 -24.5589 +612 2 9.06913 10.8398 13.0623 -1.46455 6.72769 -32.5395 +613 1 12.8789 1.33599 13.3369 -0.326833 21.0111 -2.4484 +614 2 13.4114 1.42549 12.5087 -12.3149 4.19021 14.3531 +615 2 12.3728 2.16885 13.5095 17.1543 -18.8215 -15.124 +616 1 6.3438 13.6989 2.14861 -9.76603 2.4566 0.239062 +617 2 5.66699 13.9965 2.80165 17.5467 -9.19207 -8.6938 +618 2 6.94024 13.0708 2.57673 -0.273551 -0.649347 7.27334 +619 1 15.9211 6.60722 12.7931 -16.6599 -18.553 -4.38331 +620 2 16.3967 7.19214 12.2261 12.0088 12.5524 -15.4249 +621 2 16.3823 6.6241 13.6257 5.92705 1.19016 14.7721 +622 1 16.8355 0.712467 9.59592 -3.36362 -23.3789 -3.56206 +623 2 16.7779 18.376 9.75078 1.74957 20.9638 -0.413143 +624 2 16.4581 0.840534 8.70411 1.17104 2.38037 5.50581 +625 1 6.14488 11.7511 8.38011 -0.18946 -41.167 -3.37934 +626 2 5.27459 11.5011 8.78729 18.3987 2.85732 -10.3128 +627 2 6.60987 10.8879 8.11154 -22.1828 30.5528 10.1053 +628 1 2.89693 8.62105 0.44295 -56.4203 1.00956 -31.5069 +629 2 2.27197 8.22062 18.4324 34.822 -7.67477 5.45833 +630 2 2.23776 9.23156 0.789096 17.398 15.3469 20.296 +631 1 10.1637 10.4615 6.50349 -4.04384 3.34709 -8.13679 +632 2 10.5967 9.72069 6.94847 1.64295 -0.870339 0.249421 +633 2 10.4974 10.4621 5.5852 -1.057 -0.999308 12.8758 +634 1 6.73224 15.6973 6.55436 -2.09809 -5.48823 4.73835 +635 2 7.11043 16.1412 7.33204 2.41282 1.16671 -8.98558 +636 2 7.01002 16.1566 5.74315 2.18916 7.51026 7.17736 +637 1 6.44608 13.1679 5.58195 -4.20705 -14.9444 9.79279 +638 2 6.65412 13.9682 6.06813 3.08652 7.67851 0.170606 +639 2 6.07667 12.5708 6.24938 0.761343 1.39557 -4.00611 +640 1 16.8208 12.5604 9.84104 -2.42329 -13.6856 -22.0974 +641 2 16.9708 11.9197 9.11347 0.32984 0.887075 14.5477 +642 2 16.637 13.3652 9.35916 0.987515 11.3295 4.43609 +643 1 6.04174 2.95051 2.84722 -0.719082 -29.0389 17.5165 +644 2 6.39757 3.79665 2.63265 6.28437 26.7212 -14.5644 +645 2 5.5959 2.56013 2.08759 -0.264068 2.45464 -11.4985 +646 1 10.912 3.32579 3.30021 -11.54 -3.72468 -0.286686 +647 2 10.265 3.99241 3.57025 6.99069 0.708994 3.18227 +648 2 10.4899 2.90229 2.54711 3.22659 -3.75767 -5.68185 +ITEM: TIMESTEP +20 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.70913 7.06604 17.9499 1.08039 -7.3052 -10.6944 +2 2 7.76309 6.93671 18.0927 2.86377 -0.0634365 6.14939 +3 2 8.89082 6.62218 17.113 -0.435012 1.17195 3.96762 +4 1 18.5701 8.27154 6.84569 7.63886 -4.25596 16.0618 +5 2 0.0770478 8.01704 5.94511 2.80666 -2.10014 -27.175 +6 2 0.448594 7.6266 7.34851 -2.05713 5.96795 6.45131 +7 1 8.39922 18.5714 6.82203 6.72948 10.2859 -1.45868 +8 2 9.32775 0.155905 6.65662 -6.00666 -1.87083 0.283604 +9 2 7.88802 0.6421 6.41318 2.19693 -3.22314 0.641978 +10 1 6.59462 1.83749 11.6886 4.57701 1.91935 4.50468 +11 2 5.92153 2.26167 12.2253 -5.29818 6.79114 -2.36061 +12 2 6.2022 0.990271 11.4833 -4.39091 -13.1588 -5.35683 +13 1 7.12455 5.7334 2.35273 -30.6289 32.8622 11.4294 +14 2 6.61502 6.28908 3.00258 14.1285 -25.9969 -7.59408 +15 2 6.93422 6.24286 1.54682 10.1555 -14.3812 -3.81516 +16 1 16.2065 10.1646 16.1262 8.40668 11.1152 -6.07805 +17 2 17.0895 10.2474 15.7446 -2.7739 -5.15617 3.84543 +18 2 15.9438 11.0841 16.2665 -7.12418 -3.1551 3.11568 +19 1 10.6155 14.9936 2.32061 -1.92123 -0.42827 -4.10202 +20 2 10.587 14.5409 3.17342 -1.90113 -4.17135 2.45193 +21 2 11.1106 15.7965 2.49753 3.42935 4.58062 3.08668 +22 1 17.1538 8.25609 10.4362 5.05968 0.945942 4.2849 +23 2 16.7065 8.97876 10.9029 -1.41924 -5.56537 3.25582 +24 2 18.0123 8.61559 10.168 -2.45464 0.72557 0.389593 +25 1 14.8661 15.8683 16.3562 3.75833 -10.1031 -0.407994 +26 2 13.9609 16.1531 16.2809 -17.2441 8.84265 -1.93831 +27 2 14.8525 15.2671 17.1114 5.79928 3.60638 8.20478 +28 1 12.159 13.3907 0.439783 -6.21112 9.36015 -5.49833 +29 2 12.0312 13.5738 18.1447 5.07318 -6.56614 -2.93527 +30 2 11.6434 14.08 0.875998 -3.18612 -5.19303 11.2101 +31 1 9.2695 5.40921 4.0396 -15.9764 -20.2303 6.13461 +32 2 8.8083 5.02157 4.82949 8.30048 18.0685 -17.5094 +33 2 8.61456 5.30675 3.30783 11.5288 9.4755 11.0493 +34 1 1.82939 4.25621 11.6493 -6.71206 2.38393 -0.709376 +35 2 1.74358 5.20905 11.8686 0.595776 -11.527 -1.23597 +36 2 2.30823 3.82152 12.3665 0.967745 0.8605 0.134832 +37 1 1.98223 6.83069 8.36497 -5.35455 0.0641687 -19.1444 +38 2 2.41924 7.2303 9.11786 5.68758 -2.51321 7.89524 +39 2 2.03012 5.87061 8.47368 0.241822 -0.370612 9.81388 +40 1 5.39801 4.40718 7.93771 10.9733 2.82986 12.12 +41 2 5.47637 3.44759 8.05616 -6.09239 2.90192 -10.948 +42 2 4.7514 4.61131 7.25273 -1.49389 -3.85519 0.176314 +43 1 3.26825 2.92232 17.539 -14.9988 14.8633 6.4114 +44 2 3.91862 3.43305 17.0175 -2.74895 -4.28964 2.11315 +45 2 2.69145 3.57031 18.023 20.6758 -7.505 -11.8237 +46 1 7.47034 5.2735 6.10589 -2.49502 5.37071 -3.04547 +47 2 7.84271 5.98269 6.68437 -5.78386 -20.7203 -0.884416 +48 2 6.94663 4.6123 6.60405 7.6241 17.9385 5.03136 +49 1 9.77266 7.01281 11.9821 10.4665 -1.38292 10.7277 +50 2 10.3585 6.42202 11.517 6.59042 -6.6592 -2.49871 +51 2 9.12807 7.25863 11.3259 -16.7919 6.8996 -8.63143 +52 1 14.096 3.56038 8.06303 -5.03459 -1.11151 -11.1946 +53 2 13.7156 4.24767 7.5046 0.899669 0.845681 1.92473 +54 2 14.4812 4.01512 8.80943 2.7486 3.89851 9.64387 +55 1 4.73966 17.2567 4.00996 -0.195125 14.326 -18.5317 +56 2 5.55163 17.7707 4.1353 -4.1295 -8.09403 5.71009 +57 2 4.38972 17.5915 3.15482 -7.00181 -7.87351 15.3992 +58 1 16.5025 16.6092 10.0733 13.1432 9.20378 8.07617 +59 2 15.9712 16.6856 10.8668 -9.96451 -5.5735 1.54085 +60 2 15.9848 16.1464 9.41138 -7.70063 -5.20479 -0.44901 +61 1 1.97052 4.91045 0.450899 1.06366 9.69844 4.9192 +62 2 2.61093 5.33981 1.06219 -5.49885 -10.5105 -8.09306 +63 2 1.57388 5.6737 18.6422 7.70456 -7.85061 -0.972244 +64 1 11.7662 13.3441 16.2815 -7.88535 5.38496 10.7421 +65 2 11.2704 12.5109 16.442 6.50023 4.10664 -10.6094 +66 2 12.3479 13.2575 15.5066 -9.92493 -12.14 1.82083 +67 1 10.1201 11.0576 16.9389 3.39974 -19.6625 0.923124 +68 2 10.5319 10.1651 17.0061 -5.17122 15.3709 -2.15755 +69 2 9.17725 10.8754 16.8052 5.13113 2.71984 -2.06215 +70 1 11.7111 17.5152 13.4588 11.325 -2.75861 -1.19784 +71 2 12.3718 17.1152 12.8813 -0.632983 -4.36671 1.26506 +72 2 11.9961 18.4406 13.4806 -4.40298 2.90056 2.38202 +73 1 6.35795 9.30394 12.2283 8.95317 6.42027 -9.35456 +74 2 6.91663 9.09838 11.465 -5.59359 -11.5346 -0.139091 +75 2 6.8458 10.0391 12.6013 -0.320164 5.49925 11.3434 +76 1 16.2195 12.7457 2.69542 0.295574 -29.3957 1.13627 +77 2 17.0216 13.1501 2.38091 9.97003 13.3951 -1.47132 +78 2 15.5842 13.4209 2.91145 -9.8096 20.1499 -2.69183 +79 1 0.634077 12.5728 5.88372 -7.9484 2.86768 -4.89493 +80 2 0.988616 12.3569 5.00851 -6.1101 5.76055 1.83916 +81 2 18.334 12.7959 5.71409 15.811 -6.64636 4.43625 +82 1 5.2077 16.407 18.4749 -9.68849 -0.552221 -6.28119 +83 2 5.84718 15.7794 18.0984 2.41425 5.32286 5.94338 +84 2 5.56586 16.8292 0.618687 8.26881 -4.78153 -1.34873 +85 1 0.531249 7.63213 4.08542 33.6963 23.9515 -16.2824 +86 2 18.6021 7.94352 3.35108 5.75308 0.311196 11.7347 +87 2 1.44781 8.03396 3.8909 -38.1012 -20.2476 4.98268 +88 1 3.13519 8.90219 6.5128 -18.1806 -1.10975 19.7922 +89 2 3.61721 8.66647 7.3217 -0.167991 0.711605 -10.7948 +90 2 2.18954 8.88363 6.78472 17.5501 0.713198 -9.35234 +91 1 7.30642 10.3086 16.1993 0.33826 1.86993 11.5423 +92 2 6.5825 10.5097 15.5962 -1.40069 -1.74837 7.12047 +93 2 6.94436 10.2588 17.1142 -3.68695 0.804433 -15.344 +94 1 11.1033 1.05136 4.99998 6.51415 -6.68887 15.4104 +95 2 11.3804 1.86173 4.55399 -8.93638 -1.72916 -9.27788 +96 2 10.7652 0.40817 4.35737 0.804793 8.53975 -5.36269 +97 1 4.41906 2.71829 13.1993 1.75265 -17.8891 31.6776 +98 2 4.61925 3.15892 14.0364 2.0928 12.2335 -7.50334 +99 2 4.34595 1.79439 13.5397 -3.31279 7.49147 -22.0731 +100 1 8.39429 10.0534 1.8011 7.989 6.96853 5.58503 +101 2 8.43083 10.7556 2.48299 -4.47719 -6.35615 -3.34103 +102 2 8.76263 9.25633 2.22388 -6.49712 6.95404 -2.63041 +103 1 10.5097 1.74962 15.5619 -18.3761 -0.922722 7.55335 +104 2 11.4225 1.47346 15.6803 4.80494 4.8298 -6.32182 +105 2 10.3374 2.00269 14.6445 6.81104 -1.01801 -3.49857 +106 1 2.7507 12.9226 7.76103 -0.99391 -3.54814 -5.35437 +107 2 3.2837 13.6196 7.35675 1.026 0.47841 4.16479 +108 2 2.1823 12.6261 7.03948 -5.64928 1.37633 4.69044 +109 1 3.65655 11.6901 5.29539 -1.74666 1.04695 -5.47464 +110 2 3.42979 10.9863 5.91968 -0.390133 2.11749 -7.53732 +111 2 2.90341 11.8434 4.69867 6.59799 -3.91283 3.78854 +112 1 6.86195 14.4839 16.8677 -6.59977 -5.37582 9.26387 +113 2 7.63594 13.9204 16.7929 -0.0312736 1.63672 -3.94334 +114 2 6.43125 14.5303 16.0039 6.73415 3.59122 -3.18668 +115 1 14.1795 14.5536 3.39757 15.4782 -5.44823 -10.5 +116 2 13.7027 15.3725 3.25557 -8.02005 3.41109 -0.200737 +117 2 13.6761 13.9828 3.97966 -5.46722 0.130817 9.75683 +118 1 8.30625 18.1704 16.0558 -18.3501 -5.93921 0.16691 +119 2 8.73243 17.3486 16.3757 13.662 16.7968 -4.53324 +120 2 8.86048 0.311637 15.8745 11.2379 -14.2941 4.19403 +121 1 4.7262 1.6175 4.92485 1.6266 19.4211 -17.3379 +122 2 3.85517 2.05812 4.84475 13.0303 -7.24689 7.72044 +123 2 5.31448 2.15314 4.34837 -14.7695 -11.1634 6.67198 +124 1 15.0789 12.7964 16.4332 -6.30353 8.33681 17.3183 +125 2 14.5699 13.1854 17.1557 10.6035 -4.81202 8.18161 +126 2 14.431 12.7912 15.7403 -5.45963 -10.7064 -24.7799 +127 1 15.7876 18.4014 16.8102 7.97993 -1.6905 34.0366 +128 2 16.3475 18.509 17.631 -13.1355 2.97046 -27.3317 +129 2 15.4303 17.5059 16.9211 5.07282 4.66478 -9.26997 +130 1 1.15379 1.15776 16.5585 8.66192 -1.89028 -5.04545 +131 2 1.90132 1.75074 16.7615 -7.4852 -3.92147 5.78546 +132 2 0.484053 1.2881 17.242 6.61018 5.41271 -0.381602 +133 1 18.0958 4.56873 15.8951 8.25715 -8.22974 -2.59939 +134 2 18.5403 4.03662 15.2192 -4.31028 2.25805 3.56674 +135 2 18.6753 4.5681 16.6654 -3.11748 0.528024 -3.18079 +136 1 12.2229 16.9717 16.1366 4.99185 -14.9968 15.1993 +137 2 11.5697 16.3784 16.5746 6.13992 18.0067 -10.7689 +138 2 12.0903 16.9196 15.1862 -11.661 1.79059 -6.40221 +139 1 15.9175 2.52925 17.9868 -5.04918 24.4496 -1.91719 +140 2 15.7053 3.35036 18.4645 1.43445 -9.55155 0.206063 +141 2 15.6037 2.74854 17.0829 8.19816 -13.208 8.21894 +142 1 6.7035 13.812 10.2396 3.19471 14.7437 0.534165 +143 2 6.61208 13.6203 11.1841 -1.85117 -10.3739 -2.65392 +144 2 6.65674 12.9942 9.7292 -2.15383 -4.24588 3.01674 +145 1 10.13 18.2471 2.79005 6.2323 7.4499 -7.90816 +146 2 10.2641 0.289717 2.1086 -4.88175 -4.44055 6.63338 +147 2 9.27512 17.8471 2.59242 -0.00557908 4.28296 0.85488 +148 1 2.97726 17.7544 6.09154 9.3411 -8.798 -12.7807 +149 2 2.21419 17.6669 5.51339 -17.57 2.09099 8.77855 +150 2 3.67394 17.6484 5.43984 9.00485 8.25893 -0.00709571 +151 1 12.565 16.9537 7.99058 7.14198 1.79921 -4.31208 +152 2 11.8238 16.3251 7.88339 1.67036 10.005 4.65414 +153 2 12.3624 17.6704 8.62526 -6.57036 -14.6618 3.16709 +154 1 14.8823 15.2807 8.26789 -1.91265 -14.526 28.7428 +155 2 14.153 15.9118 8.23916 -2.47753 6.09246 -10.9919 +156 2 15.4304 15.3156 7.48892 0.613021 10.1448 -23.5664 +157 1 17.5919 18.2849 0.376053 -34.2379 -2.64943 -3.08159 +158 2 18.3697 17.8673 0.0312256 25.6277 -7.0964 -1.13253 +159 2 17.798 0.454484 0.829223 12.3697 7.05842 3.85092 +160 1 0.890355 10.3869 1.40531 11.5261 -26.8893 18.421 +161 2 0.106732 9.81739 1.52594 3.68606 12.403 0.666184 +162 2 0.670163 11.0869 0.811123 -14.943 21.2909 -16.3167 +163 1 1.59243 12.2061 3.32787 10.8868 -1.98125 32.4665 +164 2 1.41581 11.4302 2.79423 -4.35317 -0.696655 -17.6875 +165 2 1.68603 12.9921 2.7891 -2.29445 2.46974 -13.9165 +166 1 0.556424 17.2525 4.88159 28.516 -3.31441 -27.2608 +167 2 -0.112492 17.9263 4.93691 -11.7284 7.93843 13.1539 +168 2 0.513874 16.5834 5.55808 -11.2757 -6.6263 16.6148 +169 1 1.11617 0.979823 9.41029 -8.01472 5.90786 -6.49609 +170 2 1.17088 0.754182 10.3385 12.3333 -8.44182 10.8127 +171 2 0.193916 0.78552 9.22994 -1.98368 -3.92324 -6.63209 +172 1 16.7786 2.33534 13.2836 0.301257 -1.02782 -8.61363 +173 2 16.9098 2.55877 12.34 -0.551981 -1.96326 12.3514 +174 2 16.5533 1.39033 13.3371 -1.81134 4.54396 -2.66642 +175 1 2.50838 15.8231 12.1881 11.0759 -0.61625 -4.91684 +176 2 3.05623 15.4799 12.9137 -5.11001 1.87196 -7.11666 +177 2 2.97562 15.6336 11.349 -1.75425 -0.738878 7.05871 +178 1 16.4241 15.5762 5.95419 20.8818 34.7414 3.73321 +179 2 17.3417 15.6388 6.29893 -10.1511 -9.39035 -1.02331 +180 2 16.3256 16.4387 5.46724 -6.92566 -23.7939 4.29358 +181 1 5.82318 5.04015 11.787 7.38202 -1.28642 -1.97288 +182 2 5.53279 5.76584 12.3478 -8.19426 6.74642 1.34004 +183 2 5.25308 4.28957 11.9879 -3.19521 -0.0404241 -0.10221 +184 1 15.2058 4.86095 0.714988 -15.0911 -0.578133 32.6943 +185 2 15.0554 4.65905 1.68214 1.80466 1.09263 -27.7183 +186 2 14.3514 5.22673 19.0716 10.184 -3.76227 -2.57358 +187 1 16.3414 16.3313 2.1188 1.69452 -20.4231 -15.1031 +188 2 15.9696 16.7397 2.89766 0.772445 11.9995 9.83785 +189 2 16.487 17.0139 1.46036 1.64169 8.90638 2.00624 +190 1 0.27953 4.87193 3.80304 22.0083 21.7264 1.42732 +191 2 0.488965 5.84197 3.75834 -13.581 -23.7134 5.51739 +192 2 1.12962 4.47493 4.05501 -10.8528 -1.93786 -0.672788 +193 1 2.93644 15.0118 15.0505 -0.31189 -6.67479 38.4938 +194 2 2.77152 14.5973 15.941 9.17422 6.49202 -18.5047 +195 2 2.6087 15.9081 15.2082 -8.55577 3.59906 -10.383 +196 1 1.11893 14.5977 9.54871 15.5404 -15.1461 3.70851 +197 2 2.05973 14.499 9.39244 4.56619 15.8955 -5.72674 +198 2 0.980037 13.7309 9.94382 -18.1835 3.0763 3.0761 +199 1 13.6623 16.6444 11.5318 -24.61 2.13122 1.95847 +200 2 13.1623 17.4223 11.2076 12.7863 -8.68657 -5.97173 +201 2 13.1098 15.8918 11.2458 9.29846 2.29742 -4.43006 +202 1 4.71401 1.48013 0.724257 -0.188744 -1.90188 8.47653 +203 2 4.10877 2.04213 0.209428 1.54459 -7.39683 1.44825 +204 2 4.1847 0.878426 1.28084 -4.13807 4.124 -10.8706 +205 1 1.4317 18.499 11.8861 -0.747589 2.74228 -9.05649 +206 2 1.26248 0.376362 12.6752 -1.22453 3.10674 7.57799 +207 2 1.76508 17.6414 12.1696 1.67944 -1.01146 1.59049 +208 1 11.5426 10.114 4.08871 14.5973 5.39555 -25.8673 +209 2 11.3947 10.5181 3.18641 4.0612 -8.18021 22.6028 +210 2 12.5241 10.0302 4.19261 -20.6338 4.9276 -1.52234 +211 1 8.35442 12.1679 3.75067 -15.8416 -4.27069 -7.38356 +212 2 9.18656 12.6319 3.95442 -10.6107 -0.215004 12.2135 +213 2 7.67679 12.3128 4.45645 22.0699 3.83678 -6.48541 +214 1 14.3334 4.02625 3.28975 21.4077 6.9275 8.44763 +215 2 15.0849 4.22802 3.89908 -16.2072 -5.96795 -3.3621 +216 2 13.5509 4.49592 3.62574 4.82101 -0.669553 -3.42678 +217 1 5.57933 1.73516 7.50739 -24.0378 -31.7376 11.0088 +218 2 4.91074 1.07012 7.91595 32.7583 31.1537 -18.2093 +219 2 5.45045 1.65908 6.53973 -4.97377 0.997246 11.1506 +220 1 17.8945 1.1186 4.8831 -1.36037 -2.43827 -6.93143 +221 2 18.5804 1.42855 4.26031 -6.60553 2.78724 7.64102 +222 2 17.8025 1.76232 5.59874 4.87877 0.216211 -3.29328 +223 1 6.83024 9.40422 4.48506 -14.9488 0.581331 -12.2421 +224 2 6.75886 9.5424 5.43046 9.61942 2.86103 10.3107 +225 2 7.75214 9.21615 4.27366 4.86133 -4.03573 4.34319 +226 1 2.68867 14.9529 1.96243 -3.68441 -0.0776758 1.15821 +227 2 3.24659 14.6776 2.70632 3.58292 1.9147 -7.42106 +228 2 3.21497 14.9558 1.15083 1.81588 -2.88288 8.16929 +229 1 17.2949 12.8929 13.1574 -7.5849 14.4302 -4.04848 +230 2 16.4401 13.3055 13.2858 -13.783 -13.5119 9.83474 +231 2 17.7157 13.6748 12.8001 24.9453 0.592093 -1.55303 +232 1 15.0095 10.5719 1.38917 -11.2702 -15.2105 -5.46509 +233 2 15.5687 11.2426 1.76309 11.9887 12.322 8.95719 +234 2 14.2298 11.0424 1.10476 -6.47688 3.25886 -0.810136 +235 1 5.70264 6.91192 4.53101 4.96234 -7.94583 8.40724 +236 2 5.98573 7.83684 4.52277 1.36545 -0.678753 -1.4492 +237 2 6.33051 6.43499 5.10591 -2.47306 1.6182 -5.79546 +238 1 8.0801 8.26782 10.1943 -2.48094 -3.5573 30.8197 +239 2 8.76371 8.85191 9.85613 0.308879 9.43682 -13.0265 +240 2 7.56027 7.88877 9.48994 -2.62488 -0.283604 -15.3664 +241 1 13.5 18.3149 5.7974 -5.02979 10.2931 3.81039 +242 2 12.85 0.37996 5.63415 -2.0272 -10.2183 1.79381 +243 2 13.182 17.8392 6.59435 1.6098 2.02728 -12.9685 +244 1 0.276709 2.57627 0.11216 -0.0492842 3.76989 10.2262 +245 2 17.9528 2.7291 18.6895 13.0336 8.33648 -1.41355 +246 2 0.811706 3.36861 0.368499 -21.4808 -7.42382 -6.02819 +247 1 12.6714 10.9997 9.76016 -23.5437 -7.71308 -4.31472 +248 2 11.7133 10.8659 9.59681 15.3229 11.3368 0.532821 +249 2 12.914 10.0869 9.9422 13.3726 -3.72203 6.47581 +250 1 0.779958 12.2601 11.0819 -4.3547 -6.1438 5.62044 +251 2 18.4678 12.2984 11.1653 -6.51403 -1.20026 -7.70008 +252 2 1.07438 12.4529 11.9792 8.34734 4.57522 -3.24255 +253 1 5.0586 7.24501 13.467 -14.0099 -7.28532 -8.10759 +254 2 5.49528 8.03405 13.1289 12.6282 1.90126 -2.15469 +255 2 5.51501 6.98287 14.2704 7.34444 5.85192 6.7727 +256 1 1.26105 6.94281 11.8301 -2.26861 -4.26975 2.97 +257 2 0.502637 7.2894 11.3564 -2.98104 -0.152382 -1.57853 +258 2 1.67901 7.71469 12.2201 5.00338 4.10874 -3.32488 +259 1 15.4732 9.48624 12.3091 -7.90575 31.4836 20.4854 +260 2 15.2888 10.4503 12.3878 3.68649 -17.5592 -11.9783 +261 2 15.3484 9.17907 13.2194 3.56004 -6.14635 -9.9625 +262 1 16.6235 12.9071 5.45115 4.22183 -17.5767 13.0612 +263 2 16.4576 13.8585 5.58703 -5.89626 -6.38642 -16.4082 +264 2 16.4453 12.6107 4.54016 -1.61972 14.741 3.30454 +265 1 6.17978 10.0207 0.140312 6.69901 -0.902574 1.02107 +266 2 5.53175 10.4562 0.704359 -7.04498 -0.0752206 -3.29626 +267 2 6.99223 10.1412 0.643131 5.59964 -6.49227 2.85612 +268 1 12.3558 6.06094 4.04059 -1.82306 -10.4932 18.2897 +269 2 12.2948 6.89378 3.5711 -3.30175 6.87328 -14.7087 +270 2 11.4523 5.72881 4.15047 2.03572 4.51633 -5.92335 +271 1 0.151611 12.8143 0.201399 6.45324 -5.46068 -3.81056 +272 2 -0.0140355 13.4798 0.883392 3.4035 3.37155 -1.9342 +273 2 18.3672 13.1447 18.0414 -1.87626 -1.08321 2.97259 +274 1 3.81145 18.5877 8.5912 1.31461 -3.73146 5.16785 +275 2 3.56882 18.0432 7.82418 -6.49798 6.54364 1.53441 +276 2 2.99788 0.372962 8.89657 -5.11276 -3.31294 -4.1744 +277 1 7.4281 17.2705 4.47377 6.46179 23.4452 -11.2721 +278 2 7.96797 18.0618 4.61565 -3.66399 -5.46425 9.5792 +279 2 7.28703 17.3462 3.52078 -0.310988 -11.8901 2.26571 +280 1 9.22893 17.063 12.2466 22.6161 -18.3078 -0.374418 +281 2 9.25634 16.2959 11.6379 -2.98004 10.6911 5.23864 +282 2 10.0783 16.9759 12.7442 -18.2994 12.1316 -6.13803 +283 1 13.3197 12.9538 7.95187 -9.96581 2.72298 -9.05352 +284 2 13.2593 12.2563 8.62517 4.24613 3.77329 1.00191 +285 2 13.899 13.6706 8.22561 11.1032 -0.425478 9.75376 +286 1 14.9719 2.96045 15.3396 1.81329 0.120121 -0.870248 +287 2 14.3995 2.21229 15.1018 3.59949 7.50345 -3.65154 +288 2 15.6901 3.005 14.6772 -10.8991 -3.85704 4.22675 +289 1 9.85324 15.5257 17.0014 3.97317 -4.57748 -3.47476 +290 2 10.3864 14.7538 16.7592 -3.54516 -0.814303 -2.23392 +291 2 9.2485 15.2429 17.6987 -0.194096 3.36496 6.55889 +292 1 11.2976 8.26736 16.5426 7.06128 19.5884 6.19806 +293 2 10.6048 7.82655 16.0501 -2.15009 -7.46249 -5.1526 +294 2 11.6506 7.64084 17.1804 -3.23764 -5.26669 1.48715 +295 1 3.80261 18.1891 16.7286 5.96532 3.63646 9.58286 +296 2 4.2558 17.5705 17.3068 2.57751 -13.4277 -2.28373 +297 2 3.88923 0.356458 17.2317 -6.08372 7.81341 -6.39572 +298 1 2.19516 4.11859 8.94937 -6.46461 1.56382 -5.27436 +299 2 3.07192 3.77694 8.7043 -7.24867 0.753394 12.5906 +300 2 2.01364 3.98399 9.90559 16.1239 2.6739 -11.0998 +301 1 9.88488 10.3605 9.72172 5.12637 14.4569 -2.91242 +302 2 9.60959 11.2332 9.33432 -0.0101703 -19.6763 14.6837 +303 2 10.1282 10.4603 10.6632 -8.0115 2.48909 -7.97128 +304 1 9.71465 0.804575 10.8512 21.7431 15.3431 10.1505 +305 2 9.2832 18.6897 11.2643 -8.53487 -4.69507 -4.97966 +306 2 9.18676 1.22081 10.1628 -13.1132 -5.80645 -3.94121 +307 1 9.20675 15.1716 10.2106 -23.935 -1.88548 4.57185 +308 2 8.85892 15.9372 9.71979 2.38257 -5.68301 1.50138 +309 2 8.39577 14.638 10.4071 17.7258 6.53325 -11.5344 +310 1 1.0072 9.34307 10.3251 -13.5607 -2.30165 -2.87521 +311 2 1.0259 10.3094 10.4263 12.3488 -1.76633 0.307332 +312 2 1.88127 8.96784 10.1532 -1.03643 13.7416 3.72628 +313 1 16.8438 4.87108 8.18901 -4.78961 0.896955 11.5039 +314 2 16.1406 5.46499 8.54396 15.0863 -10.4307 -3.41532 +315 2 17.2081 4.33923 8.92353 -6.78534 8.8584 -10.8667 +316 1 14.6587 14.7041 0.366828 1.30507 -0.478814 3.63059 +317 2 15.185 15.0332 1.12636 -7.04307 -0.464202 -11.0373 +318 2 13.8385 14.3426 0.742198 8.82268 0.591631 -2.33039 +319 1 3.54036 11.0513 9.61487 2.50715 2.61524 -7.45538 +320 2 3.63629 11.5626 10.435 -2.71976 -6.10697 -0.243655 +321 2 3.06413 11.634 8.99273 6.16009 -0.263385 5.30284 +322 1 11.0628 10.8412 1.29387 1.94664 2.31063 1.36488 +323 2 11.3352 11.6508 0.816723 -4.4237 -7.82009 8.11802 +324 2 10.1138 10.7005 1.1254 8.25661 2.0034 -0.662671 +325 1 13.2071 7.092 12.8743 -8.181 6.96481 -7.78695 +326 2 14.1492 6.89693 12.9368 4.59729 -0.0390769 -2.26511 +327 2 12.7747 6.23567 12.7699 0.0352738 -4.27477 4.68983 +328 1 9.62872 1.89049 0.957357 1.17656 -1.16236 13.2501 +329 2 8.73134 1.77169 0.632677 -1.73422 -2.0126 -6.33446 +330 2 10.2301 1.88378 0.211292 -0.739962 2.15457 -7.7161 +331 1 10.5914 13.525 4.7165 6.94092 6.03141 -14.7136 +332 2 11.5001 13.1966 4.5902 -6.55933 -2.4681 12.9436 +333 2 10.616 14.067 5.5206 3.43098 -5.16043 -1.25188 +334 1 14.3018 1.72484 10.9172 13.4371 11.1223 -9.93713 +335 2 15.1272 1.43467 10.5035 -1.81024 -10.6133 4.43081 +336 2 14.4134 2.68551 10.8564 -6.433 0.422524 6.62217 +337 1 14.6521 12.3877 11.7022 -8.45049 -6.71538 5.80805 +338 2 15.5103 12.5052 11.2413 -17.7577 -5.57988 -7.54306 +339 2 13.9188 12.0751 11.1197 22.5147 4.82958 0.534535 +340 1 8.2427 5.06906 9.80652 6.55588 21.6544 3.19941 +341 2 7.41824 5.23391 10.2944 2.41744 -11.9303 -3.89737 +342 2 8.21758 4.20856 9.37923 -10.585 -10.7296 4.55255 +343 1 1.58459 16.8369 18.3321 1.96955 3.78018 0.59611 +344 2 1.85004 17.2184 17.4898 0.0469727 3.49377 1.52109 +345 2 1.98826 15.9645 18.3052 -5.87072 -8.1408 0.0386171 +346 1 1.45085 17.2397 15.3384 19.3024 -11.6024 -7.75777 +347 2 1.52928 18.1033 15.7334 -7.82156 13.9033 4.46915 +348 2 0.523156 17.01 15.2404 -5.15812 1.64021 5.22009 +349 1 3.71432 5.60797 6.16821 -6.42766 23.1509 5.2389 +350 2 3.10788 6.20238 6.65309 4.74203 -10.8724 -0.844938 +351 2 4.31902 6.23597 5.73943 -0.58891 -7.80382 -7.69424 +352 1 12.3617 9.44178 14.1897 14.768 -21.5294 -7.13739 +353 2 12.6854 8.60646 13.7318 -7.61852 23.4532 21.1317 +354 2 12.1886 9.19254 15.1239 0.0190459 -2.13671 -14.4759 +355 1 4.02789 15.2847 6.90037 19.6963 3.91174 -8.53909 +356 2 3.59813 16.0446 6.4807 -5.57314 -2.58109 7.58101 +357 2 4.98627 15.4174 6.72455 -14.0806 -2.64155 5.91133 +358 1 0.604694 8.56382 14.8836 6.38519 14.8729 2.46932 +359 2 0.593576 9.52815 15.0331 -4.38489 -7.16014 1.99766 +360 2 1.21683 8.48632 14.1406 0.0450847 -3.26888 3.80333 +361 1 12.9907 8.33553 10.3435 -10.7244 11.0212 -25.595 +362 2 13.7217 7.85043 9.92864 1.48882 -4.14748 10.5805 +363 2 12.916 8.06476 11.2563 9.06532 -10.0671 12.5191 +364 1 15.3021 7.67479 3.50456 -15.706 -31.6797 19.6454 +365 2 14.5991 7.08356 3.22123 -2.84665 13.9574 -20.9494 +366 2 15.4859 7.21773 4.34079 18.8178 22.1978 3.49889 +367 1 17.3057 6.66581 0.0439089 -0.566439 -0.157214 -4.14934 +368 2 16.9415 5.80914 0.322205 -4.36129 9.908 -1.962 +369 2 16.5386 7.21525 18.4101 8.51434 -8.37768 3.91558 +370 1 8.82219 6.93132 7.84612 -10.1525 -9.67927 6.48857 +371 2 9.74438 7.17539 7.82243 13.4851 9.91198 -3.74634 +372 2 8.75511 6.31699 8.60098 -3.86074 2.18846 -4.69843 +373 1 12.3417 0.621389 1.18077 -6.9564 -3.41972 6.83906 +374 2 13.1525 0.726993 1.70017 3.48999 0.0677543 -9.59522 +375 2 12.4857 18.5505 0.551479 3.63823 3.88808 0.842467 +376 1 5.6677 15.1168 14.5202 -2.89809 14.409 3.62726 +377 2 4.73779 15.2069 14.7798 -2.10515 -4.92641 -4.42493 +378 2 5.95698 16.02 14.2745 1.37709 -12.0745 -2.57764 +379 1 3.85174 6.50812 1.71549 -1.87326 -9.92841 -7.94113 +380 2 3.40118 7.27684 1.32447 4.40945 3.56133 7.79633 +381 2 3.98293 6.6854 2.65555 -2.72837 5.07562 -0.486349 +382 1 3.88774 11.6179 12.2731 7.36248 2.53406 3.74193 +383 2 4.74563 11.9961 12.5096 3.21135 -1.44769 -3.24982 +384 2 3.26188 12.2215 12.6852 -7.1456 -2.35069 3.20446 +385 1 5.4326 3.86602 15.8669 5.46195 27.5847 5.5501 +386 2 6.12196 3.19729 15.7751 -0.292732 -1.96119 -5.07149 +387 2 5.89955 4.7414 15.9262 -11.6823 -23.746 -2.53289 +388 1 14.4519 10.31 4.40466 -0.198609 -22.4452 -14.1251 +389 2 14.647 9.76314 5.18938 0.972168 3.21729 -6.37484 +390 2 14.6939 9.77999 3.59617 -3.45576 13.8176 24.0335 +391 1 7.91012 17.3396 9.21881 -3.47249 -5.09989 3.31179 +392 2 7.12992 17.5549 9.76562 5.48476 5.05439 -11.164 +393 2 8.00718 17.9294 8.44912 -7.46491 1.16212 7.11091 +394 1 4.51961 14.4455 3.97665 1.46094 13.6517 19.4367 +395 2 4.57851 15.3966 4.28178 1.46521 -27.5553 -6.05216 +396 2 4.65578 13.8277 4.74009 -3.41874 17.0045 -15.0106 +397 1 14.2914 7.39173 15.7568 2.67151 4.01398 13.8033 +398 2 15.2382 7.26829 15.5879 -5.04223 1.8615 0.0507223 +399 2 14.2621 7.71182 16.6758 1.37252 -0.910778 -10.0112 +400 1 2.89282 18.2219 1.89623 16.0954 20.7868 19.4211 +401 2 2.43498 17.5738 1.38145 -10.8581 -14.0242 -17.961 +402 2 2.20473 18.7378 2.33948 1.00824 -0.59586 0.163903 +403 1 7.97772 1.60288 4.53639 1.7563 -9.68985 13.008 +404 2 7.31922 2.029 3.97737 7.04095 6.46018 -8.6135 +405 2 8.84264 2.02013 4.43356 -4.53303 1.60821 -5.92451 +406 1 2.59943 14.1332 17.7414 -8.95394 -18.2677 -2.38171 +407 2 1.94944 13.4122 17.9464 12.5244 20.6844 1.19004 +408 2 3.47205 13.7759 17.9983 -8.8914 0.728457 0.900702 +409 1 0.745112 1.69912 13.8711 11.2473 3.52367 -11.146 +410 2 0.914419 1.4049 14.7673 -7.77297 1.70239 6.88788 +411 2 18.4589 1.93825 13.7842 -0.334419 -0.897106 4.15254 +412 1 4.53599 18.6175 13.9535 -3.4557 6.59794 -4.70782 +413 2 5.46815 18.3485 13.9788 -8.18255 -2.00556 -1.03369 +414 2 4.11637 18.3402 14.7801 5.6735 0.958275 2.99437 +415 1 7.096 0.531319 18.3551 -0.694611 7.4496 8.80978 +416 2 7.23097 0.178113 17.4735 2.95576 -3.96306 -6.42653 +417 2 6.14085 0.633472 18.4745 3.33236 6.58102 0.363951 +418 1 16.0915 18.4336 14.0959 0.427379 -0.396215 -8.58483 +419 2 15.3508 17.8946 13.7703 3.59427 8.97013 10.1541 +420 2 15.9721 18.7209 15.0186 -4.35198 -12.8399 -3.85995 +421 1 10.0849 4.5187 16.2702 4.73223 -5.50586 5.92697 +422 2 10.9866 4.63155 16.5807 5.77761 8.19399 -3.69287 +423 2 10.0461 3.5611 16.1717 -6.80252 -1.66686 -4.51665 +424 1 15.8725 17.8845 4.41654 -12.5209 12.7326 5.37596 +425 2 16.3916 18.7124 4.49019 -1.68969 -11.5252 -1.94643 +426 2 14.9593 18.1341 4.67479 17.449 -5.50076 1.40971 +427 1 6.95668 17.3709 13.7302 27.0332 5.97859 23.7699 +428 2 7.35597 17.5596 14.624 -6.60353 0.436933 -26.7426 +429 2 7.73328 17.3113 13.1176 -17.9234 -0.691624 11.5164 +430 1 13.2886 6.54141 6.708 -19.4099 -8.32294 21.4331 +431 2 14.1944 6.83212 6.62317 10.4169 5.52785 -11.9279 +432 2 12.8902 6.38702 5.85009 7.8467 0.777822 -14.5162 +433 1 7.70655 2.38278 9.20977 12.6343 0.60353 -10.8933 +434 2 7.2325 2.23152 10.0347 -6.87682 0.627979 2.4454 +435 2 7.14224 2.1131 8.46352 -1.96859 -1.38987 10.9664 +436 1 15.1599 14.8609 13.6555 2.14917 -2.72077 3.1958 +437 2 15.0894 15.1454 14.5818 -4.10533 -0.470809 -6.08849 +438 2 14.3857 15.1548 13.1581 4.50097 1.9243 4.2209 +439 1 9.31836 8.32368 3.71602 18.5592 -2.51714 11.5674 +440 2 10.1335 8.79007 3.99631 -8.14035 -3.14117 -4.90658 +441 2 9.4898 7.3827 3.90713 -7.2783 5.8685 -3.93333 +442 1 17.7186 13.4905 16.4359 -1.51289 22.2408 -13.156 +443 2 16.7625 13.3639 16.3649 1.62841 -7.26982 3.16217 +444 2 17.8329 14.3608 15.9953 4.68582 -10.1291 6.26608 +445 1 5.02763 10.6563 2.64305 -2.13744 -9.22816 3.31541 +446 2 5.67739 10.1782 3.18798 -3.0773 8.85482 -0.1212 +447 2 4.59818 11.3042 3.21285 3.70326 -1.5106 2.19329 +448 1 3.72149 8.34459 10.2919 -0.179455 -7.68631 -12.7595 +449 2 3.82782 9.26393 10.0171 0.460185 9.10653 3.72446 +450 2 3.7984 8.31763 11.2506 0.24707 1.5831 -0.943414 +451 1 16.0782 7.09232 6.27704 3.78536 -20.3998 -1.61032 +452 2 16.8668 7.5306 6.63092 -6.12864 4.03671 -1.53431 +453 2 16.2929 6.14181 6.32149 -2.48234 12.3559 -4.92911 +454 1 15.1572 7.02511 9.10581 3.8117 16.1939 -22.7388 +455 2 15.9823 7.33517 9.52567 -10.9007 1.4123 -2.48218 +456 2 15.0452 7.59247 8.29613 6.45133 -12.7204 22.5185 +457 1 6.42341 13.1088 12.8743 -8.95622 -6.97199 -8.56847 +458 2 7.13157 12.5608 13.2501 0.579484 9.04377 -2.95583 +459 2 6.27581 13.8943 13.4207 1.62934 -6.42573 5.92996 +460 1 12.1251 4.48872 13.0852 20.6978 11.8008 -11.4801 +461 2 12.1861 4.63134 14.0408 -7.38726 -2.06828 2.45652 +462 2 11.3124 4.06154 12.8314 -12.072 -7.43803 9.29181 +463 1 11.3394 8.19587 7.85205 11.1059 -10.4301 17.8484 +464 2 12.0348 7.61277 7.52234 0.357557 0.521252 -13.0071 +465 2 11.6101 8.269 8.78041 -6.91702 7.4869 -1.95681 +466 1 17.1867 10.7889 7.4395 14.5297 -2.81026 -23.5185 +467 2 17.9096 10.1869 7.16109 -12.9834 1.71839 15.1597 +468 2 17.0415 11.3048 6.62611 -4.1729 8.16775 12.482 +469 1 5.24074 18.1281 11.0581 -15.2173 -3.98599 -8.34189 +470 2 4.58924 18.0057 11.7782 10.2636 1.95052 -8.13419 +471 2 4.73144 18.0737 10.2167 7.33147 4.07832 13.9505 +472 1 7.57528 17.5815 1.8237 -4.07192 12.6902 15.9513 +473 2 7.93668 16.805 1.40258 -2.93669 -7.99436 -16.24 +474 2 7.56667 18.3008 1.17772 -1.22407 -7.09592 -6.98677 +475 1 1.89335 12.9293 13.6081 -2.83392 -4.38044 7.70492 +476 2 1.42634 12.2947 14.1785 7.13969 5.03303 -2.73416 +477 2 2.14611 13.6729 14.1857 -2.01709 -2.63559 -9.61881 +478 1 9.71667 6.79197 14.8165 -19.737 27.0922 8.68981 +479 2 9.89359 5.91802 15.1417 7.60675 -24.7177 2.15595 +480 2 10.032 6.8882 13.9194 5.10262 -3.22926 -9.37061 +481 1 15.2334 4.35765 10.7756 -27.5978 -16.2477 -22.3588 +482 2 16.1684 4.22394 10.6591 16.9939 1.30069 13.5789 +483 2 15.041 5.04225 11.4098 10.4595 11.1452 11.1309 +484 1 11.214 6.13659 0.181715 -19.0514 -14.6776 -12.5318 +485 2 11.2124 5.17659 0.0304417 14.0569 6.29109 5.62342 +486 2 10.2823 6.34718 18.6411 6.7491 10.3457 6.1137 +487 1 0.148583 11.3373 15.1258 -19.5821 15.0001 -24.2151 +488 2 18.1981 11.6758 14.382 16.6378 -5.64999 24.2973 +489 2 18.7581 12.0391 15.8029 -7.9684 -6.15355 -5.02438 +490 1 7.07881 9.17505 7.27008 -6.43803 -1.74166 -4.58486 +491 2 6.45798 8.45812 7.48524 7.10939 3.15379 4.24177 +492 2 7.95401 8.76045 7.26417 -3.66954 2.28396 2.09633 +493 1 18.4168 15.4276 12.3546 -3.43386 -0.549873 -4.48624 +494 2 0.729474 15.5504 12.2627 0.527014 -4.05801 2.94094 +495 2 18.0745 15.7474 11.5108 -2.98934 0.409485 0.218187 +496 1 16.554 4.36499 5.23729 20.8954 -6.05263 25.9175 +497 2 16.7683 4.14077 6.16822 -16.8827 1.59137 -12.628 +498 2 17.4495 4.42836 4.87212 -5.6372 6.04853 -15.3532 +499 1 17.7678 3.07292 10.7257 -2.33819 12.1961 -2.64827 +500 2 0.05876 3.27172 10.9273 -5.50289 -7.01135 -0.383438 +501 2 17.6798 2.21428 10.2822 5.02163 -0.151153 2.81987 +502 1 12.2925 0.0394171 10.1485 -5.03026 26.5344 11.6637 +503 2 11.4572 0.407352 10.526 9.87088 -12.259 -12.5756 +504 2 12.9102 0.803778 10.1803 -6.63246 -15.2789 0.0865208 +505 1 10.3587 9.80679 12.3603 15.6128 10.3756 0.750657 +506 2 11.1656 9.89562 12.9016 -9.14674 -1.49827 1.04164 +507 2 10.2822 8.8615 12.2126 -4.78815 -8.04326 1.85351 +508 1 0.512396 2.83902 7.01376 3.84696 0.0782361 15.1378 +509 2 0.640445 3.53836 7.66576 0.959953 5.26089 -8.6545 +510 2 0.680944 2.06786 7.56376 2.06531 -6.50055 -6.8896 +511 1 0.435055 15.2675 6.92024 15.2549 -35.398 4.87844 +512 2 0.621058 15.2814 7.87767 -6.30652 4.63478 -5.55491 +513 2 0.767833 14.3496 6.68755 -16.1257 30.2961 -2.9732 +514 1 16.9932 7.01767 15.3053 -26.5651 1.45521 -6.17716 +515 2 17.7481 7.60304 15.1777 11.1425 -6.61607 -1.97906 +516 2 17.2478 6.0923 15.4082 16.5215 2.79636 5.68328 +517 1 9.018 12.4253 8.12635 6.95093 19.302 15.9025 +518 2 9.42759 11.8305 7.48541 -10.9396 -6.20971 -13.8418 +519 2 8.05723 12.5431 8.02215 9.94353 -10.4145 -8.12359 +520 1 1.2603 1.92339 3.03777 4.00037 -11.2111 -0.333139 +521 2 0.985763 2.4239 2.25859 3.27899 1.87382 4.37683 +522 2 1.94434 2.40743 3.53125 -8.95634 4.24445 -6.71947 +523 1 4.13152 15.1081 9.6737 -15.9579 5.42681 13.2475 +524 2 4.06185 15.276 8.72578 6.37214 -2.02945 -0.454299 +525 2 5.01049 14.775 9.87491 6.77649 -3.08542 -5.82222 +526 1 7.18656 2.18024 14.5742 6.63684 0.423238 1.66106 +527 2 6.97291 1.78224 13.7284 -0.102066 -5.66692 0.745345 +528 2 7.71431 2.94579 14.3335 0.160548 4.26015 2.86325 +529 1 18.6004 14.6938 2.16823 2.76542 -5.02319 -0.780568 +530 2 0.802927 15.1539 2.18876 5.80577 -4.93168 -0.456722 +531 2 17.9585 15.3989 2.13554 -15.1748 6.08707 3.47143 +532 1 9.94779 2.77101 12.9402 13.7079 -4.8088 0.992354 +533 2 9.86912 2.18708 12.1681 -6.43941 0.85112 1.08944 +534 2 9.26112 3.44421 12.9098 -9.63803 -0.00730006 -3.05418 +535 1 2.82654 8.93218 13.0337 -16.8853 -9.00607 0.122573 +536 2 3.25687 9.752 12.7946 6.59476 15.835 -2.70012 +537 2 3.50997 8.32082 13.3007 12.5319 -6.06263 8.37491 +538 1 3.22862 8.37837 3.65188 -0.226515 1.69475 29.0088 +539 2 3.688 9.03214 3.10752 1.26352 6.15003 5.24259 +540 2 3.37942 8.56962 4.62044 0.873457 0.138782 -29.442 +541 1 5.6209 7.19208 8.52428 9.74274 9.28918 -7.76376 +542 2 5.82768 6.24803 8.58864 -11.1579 -1.95789 2.42461 +543 2 4.98617 7.45468 9.2041 -0.288223 -8.23268 4.91577 +544 1 14.8711 1.29057 2.00464 8.31119 17.2873 -6.28041 +545 2 14.835 2.11415 2.48745 -9.33397 1.40045 17.6104 +546 2 15.2356 1.62076 1.17953 -0.998754 -14.9614 -12.238 +547 1 8.25883 15.2026 0.830681 5.29747 -5.49957 9.6471 +548 2 8.95156 15.1522 1.50066 13.8019 -1.55539 -6.59484 +549 2 7.5748 14.6468 1.22478 -8.81297 0.605757 -6.77665 +550 1 15.6232 1.34362 7.23598 -18.647 -1.91314 -11.6656 +551 2 14.9897 0.764646 6.76092 12.0508 5.58891 7.1025 +552 2 15.1447 2.18632 7.33027 3.5178 -4.19741 5.22167 +553 1 4.94904 13.0769 18.5237 9.6722 0.589191 0.374268 +554 2 5.36668 13.208 0.749415 -4.04426 -2.7658 -6.21312 +555 2 5.63686 13.3362 17.8955 -3.04446 1.7017 1.4528 +556 1 15.3696 8.47999 18.1528 -1.21138 17.1653 -12.6794 +557 2 15.695 9.10606 17.469 -1.13375 -12.9806 6.06144 +558 2 15.1122 9.07709 0.225504 3.72099 -3.98362 5.25331 +559 1 12.0892 3.03182 18.3639 -14.1234 30.4246 -7.06661 +560 2 12.0418 2.65673 0.600248 11.0312 -14.2758 -1.1161 +561 2 12.4684 2.43863 17.7097 5.58993 -13.4699 6.64437 +562 1 13.2076 12.6677 5.18878 -11.1257 12.6934 -18.8931 +563 2 13.6382 11.873 4.85103 6.50507 -2.50005 7.23376 +564 2 13.4408 12.7972 6.11334 1.90386 -8.97209 5.02297 +565 1 6.04179 7.07685 0.0416979 2.64097 -12.2137 0.441028 +566 2 5.97681 7.98433 18.9573 -0.86164 23.926 -2.06041 +567 2 5.22747 6.68409 0.369779 -2.28588 -4.24693 2.31783 +568 1 17.7316 15.9939 15.0114 -15.9363 1.83518 -2.01139 +569 2 16.8954 16.4456 15.035 -7.98632 8.38962 22.0218 +570 2 17.7728 15.8943 14.0703 21.4922 -14.9825 -23.1623 +571 1 13.1856 0.993654 16.5812 4.51688 -6.04585 -7.39508 +572 2 14.1484 0.841574 16.6066 -7.22778 -1.30407 6.3933 +573 2 12.7998 0.141541 16.3207 3.39554 1.08214 8.76474 +574 1 11.0918 14.5789 7.23122 -0.0827639 9.53574 4.16562 +575 2 10.4295 14.1218 7.74457 -13.7426 -4.81361 3.6986 +576 2 11.9118 14.1808 7.52276 7.59678 -9.08814 -4.3045 +577 1 17.5016 8.6119 2.09076 15.8147 11.2146 7.10458 +578 2 16.6678 8.4072 2.52184 -8.49554 -5.1851 -0.954934 +579 2 17.6089 8.02126 1.34907 -7.08963 -15.2245 -7.94382 +580 1 12.3468 7.97644 1.98939 8.16003 1.60059 13.0036 +581 2 12.1059 8.91014 1.92161 -4.12319 -5.14517 -8.91961 +582 2 11.9653 7.48445 1.25112 -3.43761 0.267259 -0.201848 +583 1 11.9018 14.6174 10.3415 -1.61415 6.01794 0.545715 +584 2 12.1103 13.7968 9.87035 -7.85836 7.68399 3.13223 +585 2 10.9576 14.8558 10.2015 13.8599 -12.9225 1.87067 +586 1 6.88302 7.0351 15.5985 0.0361083 -3.88964 -3.36213 +587 2 7.78537 7.14813 15.233 -9.24764 2.66089 10.2853 +588 2 6.74206 7.63616 16.3488 6.91006 -2.15529 -8.72434 +589 1 7.99721 4.71198 13.4628 5.66523 -8.00363 0.660216 +590 2 7.27921 4.81457 12.8289 -1.54019 0.966988 -4.0678 +591 2 8.48375 5.53924 13.4635 -1.88422 3.21799 -0.709238 +592 1 13.4036 12.1691 14.2716 3.14721 5.94494 7.46154 +593 2 13.2707 11.2057 14.207 -2.45791 4.15826 -3.3873 +594 2 13.8696 12.4652 13.4742 -1.1423 -6.74147 -2.23487 +595 1 14.8179 9.43426 7.29668 -6.36233 -11.9657 -8.30628 +596 2 15.5946 9.98871 7.43973 -1.00608 2.08043 5.84882 +597 2 14.0417 9.81939 7.70717 2.29675 7.38462 3.05591 +598 1 12.6631 17.0342 3.08686 -0.647851 26.0284 13.2632 +599 2 13.0189 17.4392 3.9047 -6.62985 -13.126 -8.67274 +600 2 12.0984 17.7464 2.72355 6.77056 -16.0012 0.625123 +601 1 1.16659 7.14982 17.4488 -22.2539 0.168591 -14.6305 +602 2 0.289944 6.86023 17.7803 4.99818 12.4666 0.0121858 +603 2 0.976074 7.62854 16.6106 6.60301 -8.93429 9.27073 +604 1 12.7913 5.13723 15.6659 26.8924 -5.83385 4.65231 +605 2 13.5397 4.50448 15.7352 -14.8898 5.20509 -1.35689 +606 2 13.2524 6.00122 15.6738 -9.3883 -7.24139 -3.09335 +607 1 2.50717 3.39641 5.02544 -4.94238 4.99772 43.075 +608 2 1.86502 3.10611 5.74586 16.3729 8.7954 -24.7542 +609 2 3.07143 4.08677 5.47722 -17.3542 -15.0389 -19.8763 +610 1 8.33721 11.2536 13.4671 -31.8218 12.3906 11.8554 +611 2 8.27902 11.0779 14.4347 20.4393 -8.01279 -19.4916 +612 2 9.11607 10.9377 12.9927 6.53682 -12.2231 14.6875 +613 1 12.8982 1.36842 13.3393 -2.38428 13.9081 -24.9925 +614 2 13.3657 1.32357 12.4816 4.13856 -5.14841 14.3736 +615 2 12.4149 2.20238 13.2267 1.28817 -6.58848 11.7421 +616 1 6.36101 13.6632 2.13728 5.84509 3.64922 20.165 +617 2 5.80267 14.0802 2.81815 -1.42815 -2.61112 -9.48922 +618 2 6.96781 13.1347 2.6793 2.58248 -4.73497 -8.11447 +619 1 15.9275 6.58906 12.776 -13.2255 -11.9143 -7.63467 +620 2 16.5079 7.05171 12.1721 3.66176 7.36442 -5.52267 +621 2 16.2877 6.70509 13.653 8.87525 3.50761 9.55012 +622 1 16.8403 0.7053 9.59425 -10.8287 -6.51914 0.180126 +623 2 16.6786 18.4058 9.8215 7.5744 10.512 -7.34073 +624 2 16.3431 0.86575 8.76743 6.96547 -2.88011 1.97602 +625 1 6.14042 11.7236 8.37935 -13.4401 -40.1875 -12.4491 +626 2 5.21965 11.5178 8.67227 17.9013 7.59491 -1.88002 +627 2 6.47134 10.8481 8.01351 -3.81201 28.7474 13.2691 +628 1 2.85976 8.65216 0.41009 29.1416 -12.2873 -0.261225 +629 2 2.35956 8.19684 18.3517 -12.3126 13.3733 12.5274 +630 2 2.40304 9.34487 0.902258 -18.8466 -1.4582 -10.1697 +631 1 10.1473 10.4614 6.51315 3.14709 -2.48115 -1.63688 +632 2 10.5898 9.76783 7.02035 -1.8228 -0.602608 0.477386 +633 2 10.6086 10.4674 5.65949 -3.20151 3.83187 3.87642 +634 1 6.7508 15.7003 6.55579 -3.66232 16.9823 8.74149 +635 2 7.17195 16.1106 7.3235 -0.889674 -7.99055 3.10182 +636 2 6.78205 16.4211 5.90999 7.33374 -8.97986 -9.58603 +637 1 6.44532 13.1371 5.60194 -4.00449 -9.15456 -0.382904 +638 2 6.60496 14.011 5.98141 3.67218 -1.64471 2.17047 +639 2 6.02503 12.5975 6.28414 2.5909 4.19611 1.89612 +640 1 16.8064 12.5561 9.82402 0.581653 -6.91502 5.14494 +641 2 16.9779 11.8749 9.14515 -1.61791 10.9714 -1.54419 +642 2 16.8208 13.4318 9.41997 2.06437 -4.78596 -5.13994 +643 1 6.05928 2.9442 2.82556 1.25802 -7.30262 2.82421 +644 2 6.27309 3.83898 2.57954 7.79966 17.9541 1.71249 +645 2 5.71238 2.57735 2.0082 -4.75947 -10.8151 -3.84195 +646 1 10.8984 3.29285 3.29228 5.15622 -3.79068 5.20633 +647 2 10.3299 4.01236 3.59418 -0.748764 -1.25701 -6.51467 +648 2 10.5397 2.95527 2.46424 -5.70132 0.188995 -0.608043 +ITEM: TIMESTEP +30 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.74009 7.04233 17.938 19.1777 -3.19214 -7.49225 +2 2 7.80649 7.00854 18.1244 -14.093 -2.50808 3.42214 +3 2 8.91581 6.41795 17.2214 -5.10918 0.448792 4.2696 +4 1 18.6171 8.27942 6.83462 -12.32 14.9255 -3.46236 +5 2 0.0642234 8.14825 5.88022 8.8384 -8.96826 -1.74433 +6 2 0.471057 7.61284 7.31078 8.78566 -8.6497 2.36561 +7 1 8.41948 18.604 6.83196 -7.31709 9.89495 0.0475112 +8 2 9.31705 0.18142 6.57583 5.64527 1.22556 -0.782264 +9 2 7.87491 0.677395 6.4693 3.49499 -4.79599 0.294282 +10 1 6.58709 1.81441 11.6738 -9.76955 10.2882 13.9968 +11 2 5.91112 2.25954 12.2323 7.89399 -9.20897 -13.0604 +12 2 6.23103 0.933026 11.5157 -4.21921 -5.78552 -0.720022 +13 1 7.09426 5.71845 2.37594 5.34919 -15.1759 8.94595 +14 2 6.67772 6.26147 3.06365 -7.93287 1.62685 -13.8275 +15 2 6.91151 6.0744 1.49958 -5.30903 10.9181 0.766926 +16 1 16.2033 10.1932 16.1102 25.1038 -14.8345 -4.68499 +17 2 17.1811 10.2276 15.9712 -26.7737 6.31541 3.48142 +18 2 15.8826 11.0697 16.3304 -0.495148 7.87416 1.92317 +19 1 10.6275 14.9681 2.33481 4.63974 12.4061 -8.88569 +20 2 10.5525 14.5877 3.21874 0.475518 -3.93386 2.29786 +21 2 11.1735 15.7673 2.45016 -5.17002 -7.496 3.37274 +22 1 17.1558 8.25893 10.4932 -6.40301 -0.466841 8.61163 +23 2 16.8014 9.01233 11.0035 2.41501 -9.01393 -1.96838 +24 2 17.9838 8.5563 10.1014 3.2569 5.37409 0.738347 +25 1 14.813 15.8567 16.3841 0.422148 6.97991 -3.34819 +26 2 13.9021 16.1825 16.382 -1.86689 -1.60487 0.125842 +27 2 14.9304 15.3999 17.2268 -3.27081 -1.81494 5.72738 +28 1 12.1434 13.4089 0.461034 6.76243 -11.3039 1.90058 +29 2 12.0273 13.3364 18.1404 -4.47443 10.9984 5.76772 +30 2 11.5266 14.0334 0.870976 -2.78837 -1.53089 -3.65161 +31 1 9.27697 5.43199 4.02458 -7.91052 -7.29997 -7.2337 +32 2 8.84655 5.10212 4.83549 0.848683 4.58319 -8.36746 +33 2 8.59135 5.35221 3.31849 12.3251 4.32217 11.9863 +34 1 1.81829 4.21991 11.6429 6.07059 -17.107 12.3126 +35 2 1.72876 5.16246 11.8251 -3.56412 5.27463 0.970751 +36 2 2.25117 3.81723 12.4298 -6.51129 5.35444 -16.475 +37 1 2.00161 6.82001 8.34658 4.25884 -4.64897 6.26816 +38 2 2.3883 7.2423 9.12712 0.123274 4.2764 -6.11357 +39 2 2.06217 5.87963 8.57415 -6.89287 0.824976 -4.38383 +40 1 5.40511 4.42179 7.95561 5.36611 -11.1614 7.9457 +41 2 5.37943 3.4545 8.00651 8.07147 0.734095 -1.60012 +42 2 4.74745 4.62621 7.29567 -7.31573 12.7226 -8.35968 +43 1 3.27976 2.92717 17.5269 -2.61436 17.3567 -5.43199 +44 2 3.96706 3.40529 17.0145 -5.77518 -10.9103 1.73426 +45 2 2.73687 3.63363 17.9263 6.62302 -5.15647 1.61932 +46 1 7.46558 5.28438 6.08942 -8.18758 20.8516 25.3808 +47 2 7.86532 6.07017 6.49581 9.60667 -5.12281 -7.79846 +48 2 6.93507 4.98822 6.84771 -4.13165 -15.5457 -12.384 +49 1 9.77734 7.00329 11.9774 4.77277 1.25087 12.6605 +50 2 10.3838 6.43919 11.4894 -2.2356 -0.795019 -4.50196 +51 2 9.03042 7.20515 11.401 -0.391647 0.322053 -6.58611 +52 1 14.0794 3.58589 8.07965 12.1281 -3.68665 15.0324 +53 2 13.9224 4.24013 7.41233 -5.94016 13.6931 -8.832 +54 2 14.4997 4.05823 8.8235 -7.49262 -7.6028 -6.06268 +55 1 4.66909 17.2524 3.98463 -11.974 -6.63251 3.44703 +56 2 5.54996 17.5659 4.2137 3.76078 6.9996 -9.15965 +57 2 4.29017 17.6906 3.19701 6.52868 -0.394456 6.67531 +58 1 16.4992 16.6027 10.1206 -21.6924 9.71885 22.6747 +59 2 15.7868 16.8403 10.7484 14.9981 -6.02669 -3.77625 +60 2 16.0155 16.0666 9.49209 1.7904 -6.99745 -11.6514 +61 1 1.97502 4.88502 0.412911 -0.608987 3.87721 -1.07962 +62 2 2.72637 5.27959 0.897705 -7.05745 -2.41863 1.64934 +63 2 1.49341 5.65258 18.7073 9.30006 -4.776 -0.647009 +64 1 11.7125 13.3331 16.298 -5.19121 -16.9939 -9.12414 +65 2 11.2215 12.495 16.3147 -7.17559 5.00423 10.7559 +66 2 12.3053 13.159 15.554 3.20757 8.82206 0.62976 +67 1 10.1364 11.0457 16.9267 -8.25027 -0.64471 -2.79768 +68 2 10.5138 10.1546 16.8726 -0.811727 0.343111 1.84422 +69 2 9.16904 10.9405 16.8614 10.4447 -1.98124 -2.23602 +70 1 11.7196 17.4866 13.4532 0.688277 4.88805 11.3616 +71 2 12.4565 17.1915 12.9059 2.31052 0.20251 -3.63622 +72 2 11.8417 18.4468 13.5823 3.75325 -8.25615 -8.02045 +73 1 6.38436 9.31353 12.2227 -10.6166 9.98881 15.1897 +74 2 6.82973 8.96514 11.4526 14.2312 0.227315 -7.303 +75 2 6.92633 10.0292 12.607 -0.115112 -8.7725 -6.80594 +76 1 16.2215 12.7689 2.69197 14.2202 2.36446 -2.70282 +77 2 17.0315 13.2181 2.42332 4.27042 -4.81366 0.268886 +78 2 15.6299 13.4985 2.86911 -16.5638 6.55953 0.86202 +79 1 0.643858 12.5819 5.90471 10.4355 0.0636689 -1.96923 +80 2 0.972356 12.3928 5.01972 -0.601341 2.21783 -2.79245 +81 2 18.3387 12.6591 5.78833 -5.81166 2.35718 1.0682 +82 1 5.2154 16.4273 18.4533 5.05017 -7.28804 7.26993 +83 2 5.85096 15.759 18.1791 -0.38035 -3.88529 -12.2081 +84 2 5.53459 16.6741 0.678671 -3.42073 7.449 3.19712 +85 1 0.551654 7.64481 4.10641 16.2354 21.1246 -10.5626 +86 2 18.6183 7.98546 3.39603 3.07966 -1.83327 6.1622 +87 2 1.42708 8.08449 3.93576 -19.267 -16.5837 1.18512 +88 1 3.12227 8.91534 6.50802 24.2291 -0.585626 7.1452 +89 2 3.7382 8.63748 7.22391 -17.1573 3.17125 -13.7643 +90 2 2.22482 8.81583 6.82729 -5.68465 -1.73896 5.22193 +91 1 7.30086 10.3189 16.2323 -15.6545 -0.122126 6.34207 +92 2 6.59019 10.5178 15.6183 5.33711 0.792532 -4.64 +93 2 6.81196 10.2023 17.0683 9.00195 1.1125 -0.831229 +94 1 11.1139 1.03369 5.01342 4.3303 1.68398 -12.6705 +95 2 11.3068 1.80352 4.46111 -2.07011 7.18197 9.97137 +96 2 10.7762 0.428462 4.34613 -4.44642 -9.51924 3.00218 +97 1 4.39584 2.7383 13.2149 -0.390466 4.89753 -17.2666 +98 2 4.70663 3.24132 13.9776 -1.24631 -10.9908 10.3904 +99 2 4.24133 1.79775 13.4334 4.65854 7.0575 9.14841 +100 1 8.38523 10.0971 1.80824 -1.28714 19.1329 -0.644156 +101 2 8.30354 10.8052 2.48172 0.822207 -7.93375 -7.37013 +102 2 8.79223 9.36658 2.27287 1.71369 -9.23717 4.71722 +103 1 10.4729 1.73916 15.5717 11.6995 -6.53653 -13.4069 +104 2 11.3877 1.45477 15.4183 -5.50109 4.13915 12.9036 +105 2 10.2466 2.11684 14.7151 -9.31794 0.949785 -3.28817 +106 1 2.72932 12.8923 7.77007 2.13638 -2.03638 4.95693 +107 2 3.24355 13.6603 7.47881 -3.48119 -3.6232 -2.9431 +108 2 2.14523 12.6528 7.03806 -2.13852 4.70731 1.87174 +109 1 3.67999 11.6951 5.25129 1.06179 2.30609 -7.65488 +110 2 3.48397 10.8814 5.71277 1.07183 -5.39866 6.20843 +111 2 2.98047 11.7882 4.59744 -0.426908 3.81831 -2.62473 +112 1 6.82829 14.472 16.8976 7.24547 -11.7087 -0.510459 +113 2 7.70535 14.0752 16.845 -3.98439 5.03843 1.85271 +114 2 6.50852 14.4918 15.986 -3.30226 9.38599 0.302494 +115 1 14.1912 14.5549 3.37889 -4.65321 -1.5346 -2.40618 +116 2 13.6567 15.3531 3.27958 4.16996 -0.562804 -5.50008 +117 2 13.6356 13.9417 3.87468 5.16163 -0.564442 6.07906 +118 1 8.32326 18.1549 16.0383 38.0123 0.723105 5.33509 +119 2 8.90126 17.4596 16.3629 -14.277 -18.5473 4.85232 +120 2 9.02384 0.130446 15.7883 -15.867 17.9211 -5.43461 +121 1 4.72767 1.62379 4.93271 -17.6379 -0.985038 1.9521 +122 2 3.81401 1.95679 4.84992 11.4813 -1.52324 3.97162 +123 2 5.23321 2.13073 4.30096 3.99283 5.81443 -10.8958 +124 1 15.0185 12.7583 16.4307 33.5549 -15.7429 -8.88385 +125 2 14.6322 13.2399 17.156 -17.5625 6.9837 5.99474 +126 2 14.4538 12.6352 15.6516 -10.3238 6.55553 8.00439 +127 1 15.7718 18.4254 16.841 -12.0797 -5.1952 -2.21012 +128 2 16.3284 18.515 17.6327 0.946096 -4.9786 -5.09166 +129 2 15.4084 17.517 16.8347 11.7053 8.22526 2.07191 +130 1 1.18057 1.17309 16.5558 11.0398 2.91722 -0.500753 +131 2 1.84524 1.84688 16.7601 6.86303 -5.43895 -3.7977 +132 2 0.618264 1.22767 17.321 -11.8887 1.06625 6.89733 +133 1 18.1125 4.54155 15.913 0.560198 2.18648 6.37111 +134 2 18.4591 4.08913 15.1466 2.75843 -6.08521 -5.17788 +135 2 18.7597 4.4472 16.6204 -1.36812 0.49592 -3.69459 +136 1 12.2402 16.9779 16.1352 2.31512 -6.99762 -15.3414 +137 2 11.5952 16.4515 16.6081 -8.3163 0.999648 8.5775 +138 2 12.0081 16.8315 15.1982 2.22798 9.47321 6.13039 +139 1 15.9623 2.53119 18.0207 2.93621 -4.28086 -0.122131 +140 2 15.5695 3.22825 18.5544 -2.43998 7.63429 -5.2422 +141 2 15.6676 2.68289 17.1026 2.19807 1.36349 7.25858 +142 1 6.70368 13.8359 10.2288 1.24588 -18.109 -1.49583 +143 2 6.57782 13.5214 11.1319 -1.51171 6.96132 4.85856 +144 2 6.68827 13.0063 9.72453 -2.19505 9.55036 -5.72862 +145 1 10.1309 18.2871 2.76796 -14.3596 -6.47533 0.342864 +146 2 10.2029 0.342366 2.11266 2.51428 7.52943 -3.11917 +147 2 9.22516 17.9366 2.63576 15.7336 3.88756 2.50188 +148 1 2.99532 17.7363 6.09725 27.6457 -0.367768 9.57951 +149 2 2.17297 17.7876 5.61616 -10.9588 -3.8104 -13.5012 +150 2 3.724 17.7747 5.44639 -16.7072 2.57282 0.579206 +151 1 12.5761 16.9143 8.00615 -13.9856 15.3012 3.95273 +152 2 11.7456 16.4539 7.8426 4.73348 -10.9119 -5.17088 +153 2 12.3021 17.5765 8.66814 13.2598 -3.61726 -0.932189 +154 1 14.882 15.2803 8.24971 10.681 -0.761738 -5.80123 +155 2 14.3225 16.029 8.07669 -22.8014 8.12514 9.31404 +156 2 15.4227 15.298 7.45407 7.11517 -7.78554 -3.15381 +157 1 17.6329 18.2578 0.365715 -0.853361 22.9802 4.00517 +158 2 18.5235 17.9699 0.161776 5.93848 -16.2402 -3.481 +159 2 17.7627 0.512218 0.708086 -5.13428 -6.58263 -1.39758 +160 1 0.88251 10.4012 1.38524 10.7451 13.2218 -5.20703 +161 2 0.0659506 9.93794 1.52098 -14.8693 -14.1338 10.0664 +162 2 0.630973 11.1288 0.804044 1.28572 5.25949 -2.19783 +163 1 1.64115 12.2217 3.35193 -3.18006 -13.1055 -18.8251 +164 2 1.37082 11.5062 2.75067 2.88651 -5.3868 11.6868 +165 2 1.67765 12.9428 2.72371 4.09986 15.3051 6.03005 +166 1 0.58147 17.2398 4.87485 -10.389 -0.219728 20.623 +167 2 -0.122589 17.8866 4.86961 1.40048 11.6397 -9.93657 +168 2 0.410626 16.8027 5.7206 11.49 -10.3372 -7.14723 +169 1 1.11352 0.964392 9.43077 -4.94184 3.64088 -20.8453 +170 2 1.20387 0.588778 10.3126 -0.847456 -3.79009 5.67247 +171 2 0.226103 0.72639 9.1141 8.25621 -1.04795 9.52173 +172 1 16.7603 2.33922 13.2874 -3.33679 -13.7714 7.5216 +173 2 16.8475 2.59005 12.3669 3.49604 3.27514 -7.50745 +174 2 16.539 1.38388 13.2956 1.74648 12.4468 1.52133 +175 1 2.56382 15.8252 12.169 -1.32309 5.18512 -19.2115 +176 2 3.14843 15.408 12.7949 3.95332 -3.2625 9.96296 +177 2 3.02181 15.7534 11.31 -3.03818 -3.40517 4.91625 +178 1 16.4251 15.6276 5.98753 2.75225 -2.61515 5.58966 +179 2 17.3447 15.6415 6.33695 -10.8386 4.94036 -7.12539 +180 2 16.2312 16.4474 5.48017 12.4296 -10.8984 6.26847 +181 1 5.80144 5.06794 11.7894 5.49032 -3.99323 1.93812 +182 2 5.42192 5.63452 12.4754 -2.65214 7.25607 -4.62846 +183 2 5.38258 4.20716 11.9011 -4.64894 2.39601 -1.00669 +184 1 15.1781 4.86184 0.728524 -4.34825 6.76152 14.6306 +185 2 15.2668 4.67158 1.68153 -8.60174 -1.32446 -9.75027 +186 2 14.3367 5.34751 19.2902 10.4034 -8.61994 -3.37533 +187 1 16.3306 16.3549 2.10387 -3.60874 -8.17165 19.4202 +188 2 16.1436 16.7757 2.96383 0.821724 -8.86269 -6.10473 +189 2 16.4161 17.1032 1.53428 7.22132 12.8567 -17.8694 +190 1 0.267773 4.86229 3.80408 10.7738 -14.2237 3.39069 +191 2 0.48911 5.8014 3.76313 1.80944 1.44211 5.87769 +192 2 1.0394 4.38382 4.18029 -13.1099 14.4171 -4.44332 +193 1 2.95694 15.0447 15.0954 -6.10325 -16.3486 9.96696 +194 2 2.71126 14.628 15.9563 6.59243 11.9398 -10.1751 +195 2 2.48371 15.8886 15.0723 0.827451 0.569437 4.39106 +196 1 1.13642 14.6155 9.54099 -48.9591 -6.29818 10.1377 +197 2 2.0574 14.6763 9.37448 31.1561 -9.052 1.81392 +198 2 0.917533 13.7788 10.0133 17.9146 13.2649 -10.59 +199 1 13.6267 16.618 11.5309 -14.0517 -2.94194 4.54584 +200 2 13.2284 17.3872 11.0909 1.36391 -4.96948 -3.72009 +201 2 13.0435 15.8681 11.2876 10.4622 6.11411 -5.34277 +202 1 4.69594 1.47637 0.748111 -12.1621 -0.739309 -0.414133 +203 2 4.0907 2.00679 0.20438 8.77888 0.173625 -0.66482 +204 2 4.10511 0.858084 1.19895 3.99089 -4.2391 -0.703649 +205 1 1.43799 18.5334 11.8677 4.48354 -19.5441 -2.70285 +206 2 1.28309 0.34807 12.6964 -2.38454 7.77338 6.6957 +207 2 1.65634 17.6099 12.1011 0.514199 12.3996 -0.852918 +208 1 11.5339 10.1172 4.0507 5.82948 9.6286 -18.4863 +209 2 11.2843 10.5321 3.18756 5.15824 -8.38498 16.2271 +210 2 12.5124 10.093 4.04255 -10.5657 0.881913 4.0585 +211 1 8.32129 12.1582 3.72502 1.53352 8.77417 8.44763 +212 2 9.09494 12.6645 4.01218 5.78128 -3.64141 -7.92941 +213 2 7.76311 12.2518 4.50437 -12.3191 -3.17133 -0.801295 +214 1 14.3738 4.02512 3.28302 13.4457 8.56362 13.3606 +215 2 15.0833 4.15474 3.94873 -8.39321 -4.82495 -4.85792 +216 2 13.6328 4.57269 3.59478 1.91801 -3.79011 -4.78214 +217 1 5.59001 1.69403 7.5104 -22.1497 -9.71937 -16.3739 +218 2 4.92965 1.04535 7.86703 17.0022 15.2682 -3.23125 +219 2 5.33019 1.76513 6.54994 10.6546 -4.2597 24.8978 +220 1 17.8762 1.11593 4.87562 6.9502 3.59021 1.61777 +221 2 18.6375 1.36949 4.33979 -2.23157 -1.53514 -7.48501 +222 2 17.9489 1.70322 5.63717 -7.55192 -1.12522 1.72169 +223 1 6.82082 9.41417 4.48467 7.28036 -1.61815 9.25922 +224 2 6.87733 9.61398 5.42883 -5.7945 0.587378 -0.0554941 +225 2 7.74179 9.22243 4.26363 -0.0627487 -3.5933 -6.80471 +226 1 2.67079 14.9403 1.9639 10.8093 -10.5544 22.1131 +227 2 3.25117 14.6591 2.70117 -12.0207 4.93014 -5.95014 +228 2 3.29732 15.1077 1.27121 3.13815 4.27624 -15.5237 +229 1 17.3067 12.913 13.1683 10.6019 -31.6629 4.62367 +230 2 16.4497 13.2737 13.3972 -3.78483 16.2252 -3.80314 +231 2 17.8834 13.5891 12.8053 -8.28955 15.595 1.58636 +232 1 14.9867 10.5664 1.39303 17.3246 -3.28745 6.09509 +233 2 15.5958 11.2392 1.752 -7.58668 -4.78908 -2.0363 +234 2 14.1528 11.003 1.29225 -13.717 8.26159 -1.38466 +235 1 5.69708 6.86241 4.54741 10.2551 2.99419 0.383868 +236 2 6.12873 7.74081 4.58523 -8.39477 -7.3362 -0.690872 +237 2 6.29159 6.23392 4.98874 0.140081 3.89587 3.34658 +238 1 8.04621 8.27418 10.2318 -1.25624 6.00125 -7.48209 +239 2 8.67166 8.94213 9.92965 6.80147 7.39227 7.14523 +240 2 7.62794 8.03247 9.40376 -7.32264 -11.607 2.12748 +241 1 13.4746 18.3625 5.78211 -13.502 7.51331 -2.26288 +242 2 12.7551 0.364455 5.61988 6.67968 -8.24018 -2.37745 +243 2 13.1168 17.8207 6.50434 6.50164 -0.829271 0.111391 +244 1 0.226362 2.58719 0.131375 -15.5932 24.0028 11.6326 +245 2 17.9693 2.93929 18.6394 3.5786 -16.3529 -5.12341 +246 2 0.708035 3.3711 0.44675 7.58398 -8.21165 -4.7522 +247 1 12.703 11.0237 9.75181 24.9284 -7.65781 8.94422 +248 2 11.7937 10.9936 9.46616 -11.7502 -8.38149 -1.23796 +249 2 12.9608 10.1029 9.99094 -10.5021 9.57622 -2.72207 +250 1 0.761974 12.2205 11.0816 -4.15363 -6.09516 -21.355 +251 2 18.4366 12.288 11.0674 3.38909 -0.754442 8.49561 +252 2 1.11175 12.4338 11.9478 -3.68194 5.91832 8.04416 +253 1 5.07253 7.26896 13.4467 3.90397 -0.0234352 3.77117 +254 2 5.61152 7.96046 13.0436 -1.11485 3.21213 -6.58832 +255 2 5.53238 7.13074 14.2827 -1.05457 -4.33313 3.81413 +256 1 1.23629 6.9109 11.8337 28.2892 12.95 23.6673 +257 2 0.51347 7.34016 11.3984 -13.736 7.24235 -8.87687 +258 2 1.75935 7.64669 12.2495 -13.9201 -17.9067 -15.9983 +259 1 15.4873 9.53008 12.3182 -0.383493 4.12812 -8.89679 +260 2 15.0655 10.399 12.2152 3.51435 -2.6855 7.45914 +261 2 15.2649 9.14784 13.1724 -1.90612 6.52608 2.19385 +262 1 16.6085 12.8345 5.46896 -3.55761 11.1023 -1.95777 +263 2 16.4419 13.7896 5.48874 0.313493 -0.193839 12.6146 +264 2 16.4475 12.6632 4.54137 -0.0496347 -14.7353 -8.15109 +265 1 6.20534 9.98194 0.0899104 18.0768 -8.37359 0.258846 +266 2 5.59572 10.4068 0.70246 -2.59094 3.74961 3.89273 +267 2 7.08249 9.9872 0.527613 -14.0474 2.02387 3.58276 +268 1 12.3397 6.07843 4.05984 1.81271 11.939 -8.21694 +269 2 12.2328 6.8085 3.41842 8.48996 -4.45606 3.14495 +270 2 11.4615 5.7138 4.10837 -10.8447 -6.35959 3.05037 +271 1 0.186481 12.7968 0.194157 8.45417 -0.362633 0.823389 +272 2 0.122538 13.4857 0.868002 -3.08717 1.48078 1.57348 +273 2 18.4164 13.184 18.057 -2.66731 -2.48236 -4.34426 +274 1 3.77162 18.5917 8.57827 -20.4554 1.45559 2.68175 +275 2 3.52322 17.9715 7.87805 6.33007 3.25639 -1.82086 +276 2 2.90938 0.367014 8.76804 7.74592 -0.0744794 5.639 +277 1 7.46409 17.2961 4.48316 -14.1198 -17.2275 8.02552 +278 2 7.88946 18.1398 4.59819 4.06261 16.9953 -5.43573 +279 2 7.32948 17.1504 3.54137 6.62361 8.1702 -3.03871 +280 1 9.24056 17.0796 12.2607 -1.29913 -0.841935 -6.42698 +281 2 9.19718 16.4258 11.5387 7.57092 0.344645 9.78983 +282 2 10.1052 16.9888 12.7016 -6.07497 2.05659 -6.06408 +283 1 13.326 12.928 7.96212 4.69357 25.6567 2.07593 +284 2 13.3763 12.2768 8.65803 -4.91574 -13.7878 2.50151 +285 2 13.7353 13.7181 8.35204 8.56042 -2.58857 -8.38859 +286 1 14.9538 2.97298 15.3382 -4.29462 -11.8182 -2.96981 +287 2 14.4639 2.15222 15.1644 -2.78402 11.1896 3.17375 +288 2 15.6292 2.97829 14.6488 1.75 3.70602 0.0805282 +289 1 9.85487 15.5414 16.9955 1.72232 -1.82893 -0.169847 +290 2 10.3837 14.7676 16.7382 -3.42626 -0.271454 1.71497 +291 2 9.29261 15.2923 17.7497 4.44449 2.55726 -1.27949 +292 1 11.3089 8.30526 16.5494 -6.04997 -6.2326 7.21044 +293 2 10.5881 7.89563 16.0543 2.01853 1.78394 -3.12513 +294 2 11.4835 7.65722 17.2517 2.74023 7.81545 -1.84368 +295 1 3.836 18.1836 16.7517 -7.13385 -19.1452 -23.0441 +296 2 4.27407 17.4593 17.223 1.84106 9.67264 7.83483 +297 2 3.88222 0.348533 17.2402 4.94653 11.64 14.7969 +298 1 2.18178 4.13609 8.93005 8.1701 -0.774865 9.73019 +299 2 3.0913 3.90524 8.75773 5.46766 -1.37508 -11.1104 +300 2 2.14869 4.01328 9.88774 -11.2166 4.12208 2.959 +301 1 9.87742 10.3647 9.70242 2.63105 14.1486 10.9213 +302 2 9.56679 11.2208 9.35298 -0.359428 -9.80694 -0.658425 +303 2 10.1334 10.5423 10.6269 -4.00587 -8.10964 -6.10976 +304 1 9.70429 0.823826 10.8553 -14.0108 4.16215 1.0267 +305 2 9.1278 18.77 11.1938 11.0832 -7.32823 7.11532 +306 2 9.14207 1.22722 10.1856 4.51331 8.02138 -6.87563 +307 1 9.20617 15.1402 10.2178 -11.609 -5.72992 -0.101326 +308 2 8.7465 15.767 9.6415 2.03963 4.50002 1.17892 +309 2 8.51696 14.4821 10.4282 6.2553 7.07807 -5.66984 +310 1 0.996164 9.40777 10.3157 -31.4617 35.4735 1.80375 +311 2 1.02993 10.3821 10.3914 -11.0752 -10.4846 4.01107 +312 2 1.89609 9.22017 10.2201 37.6387 -20.6805 -6.1303 +313 1 16.8786 4.85128 8.17759 -11.2506 16.3288 -5.48708 +314 2 16.2388 5.56314 8.38188 8.44756 -9.04525 0.78656 +315 2 16.9626 4.34108 8.98054 4.36808 -7.38136 2.74573 +316 1 14.6815 14.711 0.319263 14.4838 0.937126 -3.06264 +317 2 15.2721 14.9301 1.06391 -7.87321 4.75235 -6.44468 +318 2 13.8763 14.3724 0.714255 -5.91657 -4.41648 2.02008 +319 1 3.57415 11.0448 9.58418 2.91679 3.40936 2.58946 +320 2 3.69173 11.5263 10.4228 -3.34733 -6.02301 -1.37626 +321 2 3.07399 11.6483 9.00652 3.80152 0.245021 0.575116 +322 1 11.1013 10.8086 1.33492 -13.1151 -1.75228 0.351043 +323 2 11.4484 11.639 0.990604 2.68761 3.85867 -0.677593 +324 2 10.1644 10.7789 1.04773 13.6271 -2.80152 6.25142 +325 1 13.1828 7.11823 12.837 13.875 6.93007 -2.08809 +326 2 14.1546 7.00576 12.8731 -8.73741 -0.33434 -1.11439 +327 2 12.8407 6.21951 12.8306 -5.12621 -6.60309 0.0889066 +328 1 9.62491 1.88499 0.973614 -3.42399 -6.06492 -12.2684 +329 2 8.82152 1.4846 0.597998 2.34171 8.22807 3.07369 +330 2 10.1781 2.12743 0.21359 -0.384483 0.556473 6.61436 +331 1 10.6031 13.5334 4.66686 13.636 -3.8461 -1.22567 +332 2 11.4763 13.1252 4.55872 -4.58351 -5.15517 0.0143246 +333 2 10.7077 13.9241 5.53959 -7.66657 9.10334 4.04553 +334 1 14.3485 1.75735 10.9256 -1.10429 -17.7549 1.09656 +335 2 15.1861 1.44338 10.54 -2.80824 6.90847 2.1648 +336 2 14.3834 2.71874 10.9625 8.08978 3.11888 -5.0019 +337 1 14.6333 12.3432 11.6996 -1.39952 -9.16637 -24.1357 +338 2 15.3681 12.4502 11.0746 9.0546 4.11007 14.4837 +339 2 13.9355 12.122 11.0753 -11.0061 -2.1546 9.49113 +340 1 8.24004 5.06512 9.81661 -6.73852 -15.0928 -6.1646 +341 2 7.43321 5.24609 10.2868 -7.68507 10.8263 10.6715 +342 2 8.07004 4.14881 9.53169 13.9201 5.19095 -3.88371 +343 1 1.57861 16.855 18.3455 -3.6047 -18.8696 23.6299 +344 2 1.81992 17.2862 17.5419 10.6717 7.49965 -18.3027 +345 2 1.88846 15.9289 18.2434 -7.51751 10.9825 -1.36554 +346 1 1.48469 17.2399 15.3369 -30.5992 8.85894 1.58219 +347 2 1.52903 18.0991 15.7763 5.64601 2.15314 -3.36931 +348 2 0.515015 17.0623 15.2815 21.6878 -4.25813 -0.913042 +349 1 3.6961 5.66103 6.13276 1.27154 -4.68408 -0.174538 +350 2 3.02861 6.15393 6.634 5.94065 6.05513 -0.564102 +351 2 4.2706 6.29315 5.66099 -8.13711 -1.6893 2.05746 +352 1 12.3863 9.46112 14.1898 5.64676 -22.9439 1.72589 +353 2 12.6155 8.61212 13.7476 3.53191 14.2422 4.21489 +354 2 12.2183 9.16782 15.1036 -0.67103 6.17556 -4.58111 +355 1 4.03262 15.2884 6.88962 -6.96122 -2.16466 3.53978 +356 2 3.61008 16.076 6.4989 3.67472 -5.21865 6.04109 +357 2 4.98914 15.3892 6.82497 3.29203 7.08348 -5.36605 +358 1 0.610585 8.57451 14.9167 2.06858 8.16468 9.66942 +359 2 0.571526 9.5334 15.101 -0.509723 -6.74541 -4.80249 +360 2 1.24768 8.49017 14.2004 3.24343 3.39805 -1.00154 +361 1 12.9947 8.30502 10.3347 -2.10898 5.96297 -3.02925 +362 2 13.7245 7.79451 9.98073 4.34503 -3.62623 -11.9067 +363 2 13.0194 8.04092 11.2546 -7.35013 -0.655157 9.61409 +364 1 15.3021 7.68636 3.53463 20.0464 32.042 -6.64886 +365 2 14.6007 7.2355 3.06802 -7.18972 -17.1123 8.01585 +366 2 15.7144 7.29713 4.32433 -16.1768 -11.7678 -0.766084 +367 1 17.3034 6.68003 0.0493874 -1.84179 -13.5509 -2.88881 +368 2 16.9519 5.78424 0.161568 0.711034 6.10552 3.25575 +369 2 16.5083 7.2036 18.5276 -0.473138 7.46776 -7.84911 +370 1 8.84315 6.93181 7.84628 -0.943806 11.0529 -13.3888 +371 2 9.77771 7.20927 7.80441 -6.03996 -2.82935 4.46193 +372 2 8.74315 6.27043 8.54219 4.24547 -3.80386 5.92931 +373 1 12.3578 0.616451 1.20223 7.02437 -6.39463 -1.478 +374 2 13.2861 0.535705 1.47006 -5.02329 6.70293 3.96338 +375 2 12.2631 18.6802 0.444477 -1.70715 1.25222 -1.43865 +376 1 5.64724 15.135 14.5406 -0.604856 -11.7009 0.79572 +377 2 4.70142 15.1669 14.7844 5.92695 5.15448 -4.69419 +378 2 5.94602 16.0188 14.2721 -2.36621 0.047849 -2.09121 +379 1 3.86203 6.47491 1.73695 1.36817 -0.22553 5.39386 +380 2 3.46749 7.3178 1.48065 -2.80916 3.79134 -8.60259 +381 2 4.09027 6.61791 2.66801 -1.52617 -4.74348 -3.78665 +382 1 3.89615 11.6258 12.3135 -4.96985 -7.23752 -2.42851 +383 2 4.76636 11.9561 12.5635 2.33504 5.86151 0.242199 +384 2 3.23901 12.1927 12.7515 8.69891 -3.88643 -0.482475 +385 1 5.40213 3.8611 15.8693 10.8945 -12.2769 2.09816 +386 2 6.15363 3.21949 15.8699 -18.4435 12.0745 -5.1575 +387 2 5.79254 4.73962 15.8533 3.23601 3.32406 0.742539 +388 1 14.4255 10.2871 4.42158 -5.00773 -17.9107 13.5675 +389 2 14.5181 9.70279 5.20492 2.69814 10.8256 -8.91808 +390 2 14.7837 9.77905 3.68069 -0.206993 2.85241 0.289205 +391 1 7.87167 17.3723 9.20121 -10.8695 6.25183 -3.73994 +392 2 7.03582 17.6433 9.5986 1.28641 -7.15132 6.24862 +393 2 7.9635 17.9776 8.45108 8.3983 -5.79413 -1.77097 +394 1 4.52981 14.473 3.9851 -7.27149 14.4717 16.1092 +395 2 4.4292 15.3844 4.34508 5.86047 -13.4028 -12.5476 +396 2 4.51094 13.8931 4.76638 0.622359 -0.721789 -7.97238 +397 1 14.2548 7.40188 15.768 -9.88191 3.80355 1.83721 +398 2 15.2055 7.32768 15.6782 10.3356 -1.93634 -2.70959 +399 2 14.1214 7.72007 16.6658 2.42251 2.42868 0.921806 +400 1 2.92318 18.2319 1.90056 8.21916 -2.84793 -3.01579 +401 2 2.38261 17.6158 1.3774 3.82694 3.92633 -2.29165 +402 2 2.32657 18.895 2.2462 -10.4983 4.84254 7.82145 +403 1 7.9872 1.59624 4.55123 -13.2342 7.82044 -5.09514 +404 2 7.38456 2.15817 4.04087 -4.12207 -9.74777 1.09289 +405 2 8.829 1.94177 4.28864 19.9647 -0.586446 1.64736 +406 1 2.52886 14.1331 17.7106 9.56011 -8.28606 7.0204 +407 2 2.01365 13.3855 18.0679 -1.20108 10.5585 -3.23507 +408 2 3.45026 13.9294 17.9721 -7.58546 -2.42865 -2.00823 +409 1 0.784808 1.71729 13.877 -22.3729 3.14932 11.7627 +410 2 0.820241 1.39718 14.7912 6.0833 4.21121 -6.47959 +411 2 18.4913 1.99435 13.7832 17.5446 -4.15928 -6.69512 +412 1 4.49906 18.6473 13.9354 -18.7945 1.8826 8.61585 +413 2 5.41644 18.4141 14.0419 11.9469 -5.27484 -6.26214 +414 2 4.07897 18.3597 14.7657 2.79866 5.45516 -5.58976 +415 1 7.09283 0.599142 18.3486 34.6471 -4.12786 -6.63011 +416 2 7.39021 0.234617 17.4878 -9.84259 3.28252 9.67216 +417 2 6.14438 0.553251 18.3894 -16.3447 5.16139 0.014819 +418 1 16.0881 18.4309 14.0453 5.06229 7.716 24.0321 +419 2 15.2482 18.0804 13.8032 -16.2536 -8.6858 -12.6141 +420 2 15.9952 18.587 15.0073 9.58514 -0.127307 -10.5143 +421 1 10.0776 4.50678 16.2676 12.8821 37.0646 3.31891 +422 2 10.9819 4.89306 16.3611 -10.6263 -20.5161 -3.34059 +423 2 10.1424 3.55939 16.3223 6.24363 -16.5382 -1.58612 +424 1 15.8992 17.8398 4.41934 12.2004 7.51097 -4.98004 +425 2 16.3832 18.6941 4.42415 -3.71288 -10.9395 3.02327 +426 2 14.9903 18.0494 4.62819 -9.96916 6.21932 6.5896 +427 1 6.98832 17.3871 13.7576 13.6855 5.49553 14.8404 +428 2 7.37965 17.5993 14.631 -4.71479 -0.449691 -14.3122 +429 2 7.76575 17.2997 13.1656 -13.1106 -1.1113 5.84114 +430 1 13.2824 6.5097 6.67953 4.56939 11.9611 -5.54075 +431 2 14.0532 7.04843 6.47095 5.72005 -2.26771 11.4806 +432 2 12.9258 6.37058 5.8058 -10.6331 -8.36185 -8.97535 +433 1 7.75109 2.3756 9.23631 -5.33505 -3.40336 15.3372 +434 2 7.18759 2.24157 10.0186 8.87424 2.78019 0.355864 +435 2 7.20141 2.0575 8.52046 -4.61968 -0.366971 -12.063 +436 1 15.1734 14.8403 13.6669 0.441467 -1.73197 5.96822 +437 2 15.0738 15.2212 14.5455 0.591215 -4.0348 4.14746 +438 2 14.518 15.2716 13.122 -1.09719 2.73458 -8.10719 +439 1 9.35119 8.31644 3.739 2.66762 7.66889 5.69365 +440 2 10.15 8.71947 4.13947 -5.98752 -7.29531 -6.80605 +441 2 9.38201 7.35632 3.87197 4.69073 2.10751 1.74529 +442 1 17.751 13.5231 16.4139 1.76506 1.52762 0.696064 +443 2 16.8205 13.2419 16.3833 1.32585 7.25436 -2.93419 +444 2 17.8025 14.3962 15.9827 -4.54797 -4.37418 0.927992 +445 1 4.99908 10.6417 2.69781 -10.2301 11.821 9.59097 +446 2 5.61637 10.2237 3.29708 11.0389 -6.03173 2.08237 +447 2 4.70065 11.4181 3.20566 0.509198 -9.80178 -10.0294 +448 1 3.73671 8.33589 10.2301 0.811909 12.56 -11.1256 +449 2 3.79833 9.26935 9.95307 1.30999 -3.93497 -1.66187 +450 2 3.73931 8.38186 11.1831 0.045476 -4.76093 8.99044 +451 1 16.0469 7.05349 6.21752 -8.36922 7.98368 -7.54927 +452 2 16.8656 7.47651 6.4961 3.44749 0.07849 4.67395 +453 2 16.1438 6.1088 6.32704 6.52122 -4.4821 -3.05144 +454 1 15.1289 7.04368 9.08785 10.4694 9.8467 1.75835 +455 2 15.8264 7.38614 9.67453 -3.18259 -3.19274 -6.50653 +456 2 15.1274 7.66298 8.34243 -1.48772 -3.73631 0.00250057 +457 1 6.37899 13.0555 12.8241 7.15095 -9.93714 4.62427 +458 2 7.14263 12.6042 13.2293 -5.49135 0.351509 -10.6671 +459 2 6.23455 13.8287 13.3737 -7.10156 7.81238 6.40695 +460 1 12.1361 4.49173 13.0886 -33.3605 -9.49617 -7.12831 +461 2 12.0495 4.6518 14.0281 12.9755 3.95225 11.8447 +462 2 11.274 4.06082 12.879 23.5373 6.19102 -2.9945 +463 1 11.3516 8.18262 7.87035 -14.4325 7.02786 -3.11936 +464 2 12.0471 7.65769 7.46008 8.6713 -7.43794 3.47117 +465 2 11.5359 8.26397 8.81258 10.0684 -2.50636 2.15934 +466 1 17.1915 10.8124 7.44959 -16.1176 10.6393 13.8832 +467 2 17.9047 10.1798 7.28217 -0.931293 1.13858 -10.0543 +468 2 16.9855 11.3827 6.68215 10.1883 -6.89581 1.62445 +469 1 5.25104 18.1119 11.0466 -2.03712 6.82198 -5.53245 +470 2 4.55844 17.9395 11.7023 5.22213 1.54215 -0.259713 +471 2 4.79647 18.4173 10.2467 -3.05137 -7.80568 1.06144 +472 1 7.59144 17.5428 1.82585 2.02366 6.3387 -27.4892 +473 2 7.8094 16.7742 1.27336 1.17923 0.135637 10.7354 +474 2 7.55288 18.254 1.15356 -7.65387 -5.36774 12.2151 +475 1 1.92063 12.9184 13.6023 -9.91855 -8.75107 -5.23832 +476 2 1.37345 12.2779 14.0844 5.59931 4.65398 4.03533 +477 2 2.08932 13.6638 14.189 3.88592 4.92281 2.07481 +478 1 9.68002 6.79239 14.8375 -5.9785 1.55821 1.53848 +479 2 9.8605 5.87105 15.0454 -1.79232 -6.14635 7.43903 +480 2 10.0701 6.92553 13.9753 -0.129146 4.69231 -11.1498 +481 1 15.2463 4.32976 10.758 3.34542 15.1712 12.775 +482 2 16.1952 4.27653 10.855 10.1577 -17.3864 -7.84826 +483 2 15.0718 4.96713 11.4544 -13.5892 3.80238 -1.28771 +484 1 11.2223 6.14234 0.184515 14.935 15.986 0.702496 +485 2 11.3427 5.2537 -0.179589 -9.34658 -3.11564 3.17557 +486 2 10.3073 6.45674 18.8196 -5.33379 -13.1911 -7.29958 +487 1 0.101128 11.3538 15.0994 -20.5112 19.1646 -16.3994 +488 2 18.0631 11.5965 14.4157 17.8209 -6.40715 11.0417 +489 2 18.7281 12.1498 15.6639 -2.69532 -11.5931 2.167 +490 1 7.07341 9.21118 7.26397 13.6545 -4.38359 1.14819 +491 2 6.46912 8.52168 7.54812 -6.91606 -6.22713 3.38737 +492 2 7.94495 8.78194 7.35853 -7.81842 8.24868 -3.32543 +493 1 18.379 15.4045 12.3485 -3.73833 -6.55761 4.14497 +494 2 0.693581 15.4288 12.2501 6.70794 3.85833 -5.56408 +495 2 17.998 15.8269 11.5664 0.97425 0.444703 -1.66759 +496 1 16.5516 4.36462 5.23826 -5.38189 5.67955 -17.8631 +497 2 16.655 4.28498 6.19256 13.2509 -4.37544 3.08954 +498 2 17.3965 4.59413 4.7818 -8.47419 -6.89051 15.5314 +499 1 17.7443 3.09877 10.7286 3.04827 -10.7181 -6.87848 +500 2 0.0283995 3.26624 10.9392 2.02267 5.05617 3.97045 +501 2 17.7464 2.2027 10.3321 -6.96828 10.7891 3.50943 +502 1 12.2779 0.0212452 10.1338 -0.475788 -3.12763 3.03365 +503 2 11.45 0.377358 10.5143 6.17492 -0.459139 -6.32122 +504 2 12.9469 0.721114 10.1609 -4.48032 5.31969 3.75096 +505 1 10.3747 9.79435 12.3975 0.995366 2.64477 2.84838 +506 2 11.0916 9.86004 13.0462 0.88472 -0.940912 -1.26785 +507 2 10.2331 8.84374 12.2815 -0.892889 0.226532 -0.81052 +508 1 0.549483 2.84316 7.02126 -1.47246 -21.9217 -16.5589 +509 2 0.577314 3.5439 7.66737 3.67317 4.63089 12.4819 +510 2 0.765862 2.00117 7.45653 1.04632 13.6877 4.9994 +511 1 0.405258 15.2829 6.93023 -2.49907 -5.43649 4.98244 +512 2 0.538371 14.8975 7.8327 2.16571 9.44122 -16.3162 +513 2 0.725684 14.6278 6.28848 -1.93707 -3.30699 10.9749 +514 1 17.0129 7.01771 15.2646 8.6122 -7.5627 -5.22629 +515 2 17.8138 7.53109 15.1273 -3.20292 15.4854 -2.58719 +516 2 17.4051 6.15342 15.4314 -10.2841 -6.73634 6.86556 +517 1 9.05466 12.4444 8.11302 13.0521 -10.4864 -20.5516 +518 2 9.3276 11.8473 7.39447 15.1337 1.48797 7.8591 +519 2 8.12011 12.397 7.99286 -24.7878 10.4099 9.23055 +520 1 1.26093 1.88381 3.01396 9.71768 11.5305 -0.318626 +521 2 0.781341 2.25664 2.27301 -4.68813 -2.91629 -4.97973 +522 2 1.78505 2.63319 3.35529 -3.04295 -14.2735 3.58948 +523 1 4.11799 15.1078 9.73252 4.576 2.76804 -1.92408 +524 2 4.09335 15.377 8.80945 -5.53143 0.588802 -2.3225 +525 2 5.02333 14.7824 9.83323 -1.70794 -2.53339 7.76874 +526 1 7.21252 2.18262 14.5895 -3.17269 -14.8219 8.52343 +527 2 7.02371 1.74902 13.748 4.05246 3.09826 3.19753 +528 2 7.71073 2.97164 14.4061 4.58862 11.2949 -7.92291 +529 1 18.5773 14.6793 2.1781 -14.8885 -13.9434 -3.10254 +530 2 0.806981 15.0773 2.13409 4.68638 9.16713 1.06255 +531 2 17.8879 15.3584 2.08187 6.00104 3.32119 3.09374 +532 1 9.95988 2.75708 12.9307 -3.19888 4.8993 -0.068744 +533 2 9.83509 2.14797 12.1955 3.80206 -8.82317 -3.94881 +534 2 9.20326 3.3528 12.8696 -1.08171 3.11286 5.06453 +535 1 2.85334 8.94069 13.0534 -9.07349 -10.7547 -1.24525 +536 2 3.30632 9.75091 12.8027 2.98523 12.1914 -0.768468 +537 2 3.53212 8.32042 13.3313 9.61222 -2.32206 4.81477 +538 1 3.22451 8.40753 3.67121 22.1548 25.1655 0.793749 +539 2 3.78763 9.07745 3.2153 -17.2399 -11.2925 0.757254 +540 2 3.40605 8.58793 4.60238 -4.67213 -6.04062 1.9181 +541 1 5.62069 7.18926 8.53747 6.69229 -2.05947 9.74796 +542 2 5.86853 6.28591 8.76536 -0.744086 -3.6627 -12.9201 +543 2 5.09246 7.43537 9.3012 -7.69944 9.66912 -1.05292 +544 1 14.8771 1.33506 1.99369 -4.37531 -14.3045 14.6387 +545 2 14.6174 2.14132 2.47402 3.99094 2.69357 -12.1219 +546 2 15.1274 1.48157 1.08098 3.94771 15.4277 -5.2716 +547 1 8.29964 15.2018 0.824762 -0.280237 2.12341 -18.5848 +548 2 9.0741 15.0554 1.38374 0.657448 -4.01578 8.69554 +549 2 7.56069 14.656 1.13255 5.04945 -5.16558 7.75703 +550 1 15.6052 1.34643 7.22407 3.75056 4.73875 0.699016 +551 2 15.0587 0.773182 6.67423 -5.35564 1.12746 0.995868 +552 2 15.1053 2.16848 7.37587 -1.8024 -6.33902 1.47434 +553 1 4.99443 13.0609 18.5093 -5.69789 -0.343563 -13.2097 +554 2 5.39232 13.2306 0.720212 5.08054 -1.92613 6.3414 +555 2 5.7137 13.1567 17.8693 -5.50653 4.49423 4.11534 +556 1 15.3782 8.49607 18.1492 -5.08872 -0.806473 3.30258 +557 2 15.7135 9.0139 17.4023 0.0404722 4.09908 2.1153 +558 2 15.1698 9.14329 0.203973 4.81283 -1.94937 -4.21801 +559 1 12.0917 3.05456 18.3485 5.25344 -19.9367 5.19329 +560 2 12.3328 2.56101 0.492796 -7.10973 11.5886 11.7441 +561 2 12.4167 2.41374 17.7115 -1.86526 8.77132 -18.5664 +562 1 13.1991 12.6728 5.17615 -0.124316 -0.0560055 4.18836 +563 2 13.6438 11.8331 5.03438 2.42254 -3.05364 -13.3032 +564 2 13.4089 12.8359 6.10375 -5.84435 4.2533 1.84347 +565 1 6.03469 7.1207 0.0631469 12.4635 -7.18562 -1.52206 +566 2 5.88549 8.01359 19.0305 -4.09863 7.65543 -4.79966 +567 2 5.21365 6.64029 0.190066 -5.29753 1.61074 5.21091 +568 1 17.6997 15.9613 14.987 30.7149 -12.4194 32.4504 +569 2 16.8862 16.4214 15.1458 -18.1669 6.52853 -13.961 +570 2 17.8877 15.7083 14.0822 -14.2113 6.66636 -19.3843 +571 1 13.1806 0.977208 16.5993 3.21446 -7.78263 -3.05852 +572 2 14.1069 0.725878 16.7441 -1.84519 3.55213 2.46319 +573 2 12.7536 0.148831 16.339 0.610986 0.436683 6.04854 +574 1 11.0624 14.5912 7.28204 -11.2181 -3.76258 -2.73638 +575 2 10.3867 13.9846 7.62705 2.11873 3.9908 3.08505 +576 2 11.9143 14.2091 7.50586 0.261112 -7.43153 0.664812 +577 1 17.506 8.58052 2.09005 -0.444247 -11.7988 -12.468 +578 2 16.6642 8.31502 2.4773 -2.50704 5.84538 6.9832 +579 2 17.563 7.99026 1.31874 6.86903 3.37396 8.78538 +580 1 12.3502 7.95652 1.98027 -3.36099 -5.49894 -2.13311 +581 2 11.9195 8.80992 1.98547 0.506131 9.65618 1.3531 +582 2 11.9377 7.50693 1.23044 6.6222 -7.49408 4.60604 +583 1 11.9327 14.6311 10.3511 -13.8226 21.3891 7.58711 +584 2 12.0851 13.8189 9.91206 10.3006 -23.5502 -10.4516 +585 2 11.0014 14.8158 10.1424 3.95037 3.15478 8.54077 +586 1 6.86541 7.01247 15.582 10.3214 -0.24422 -5.9518 +587 2 7.78025 7.06796 15.2658 -3.95377 -6.01896 -2.62563 +588 2 6.83046 7.729 16.2102 -7.67029 5.21932 8.6005 +589 1 8.00165 4.68416 13.4443 -21.8863 -22.7248 -23.0503 +590 2 7.36443 4.84116 12.7101 7.64348 -4.39085 15.7408 +591 2 8.44337 5.50298 13.5544 13.6077 24.8283 3.95349 +592 1 13.4082 12.1692 14.291 7.74384 0.583631 -6.74495 +593 2 13.3391 11.2097 14.1788 -8.03609 -0.555633 4.00216 +594 2 13.8852 12.4587 13.496 -2.17037 2.06617 1.19415 +595 1 14.784 9.43826 7.28323 -11.1269 12.8929 16.9671 +596 2 15.4951 10.0466 7.55684 1.33033 -10.8665 -8.82607 +597 2 14.017 9.71262 7.81429 7.01149 -4.68319 -9.50468 +598 1 12.6837 17.0142 3.10751 10.9269 -13.9095 9.51878 +599 2 12.9708 17.2813 3.99359 -6.48615 4.53386 -3.20168 +600 2 12.1282 17.7068 2.75827 -7.19321 10.5694 -1.73823 +601 1 1.13983 7.14905 17.429 -19.8537 -0.642492 -7.24746 +602 2 0.229092 6.89189 17.6928 9.24629 12.0374 -0.554306 +603 2 1.04788 7.63326 16.5858 1.73105 -6.23108 5.83737 +604 1 12.8283 5.10796 15.6891 -3.1105 -1.51238 -5.72518 +605 2 13.5351 4.46064 15.5231 -0.330328 2.49365 6.49287 +606 2 13.2544 5.98171 15.6287 1.13166 -7.6156 1.26811 +607 1 2.48175 3.38612 5.07416 -11.4746 -6.3359 16.597 +608 2 1.87059 3.13723 5.824 15.2627 10.0051 -19.3068 +609 2 3.07561 4.08306 5.41325 -9.83136 -1.83582 -2.79497 +610 1 8.32062 11.2204 13.4908 14.3326 -12.3724 2.23055 +611 2 8.41586 10.9603 14.3918 -15.5351 3.38632 26.9235 +612 2 9.1195 10.7822 13.1796 -2.73354 4.12568 -26.6086 +613 1 12.9112 1.40899 13.3219 3.38587 -22.7152 11.6955 +614 2 13.5257 1.21801 12.5994 -2.66679 10.6744 -3.40434 +615 2 12.4724 2.23119 13.1327 -1.22779 13.5514 -6.35015 +616 1 6.39925 13.6301 2.14388 13.7527 -0.778699 -6.56015 +617 2 5.84347 14.0897 2.78318 -1.88549 -3.79567 9.96763 +618 2 7.03431 13.0755 2.63977 -7.58465 4.89894 -0.0461429 +619 1 15.9327 6.56061 12.7538 -0.9836 2.19135 -10.6596 +620 2 16.5146 6.98287 12.103 -5.34808 0.40017 1.48081 +621 2 16.2873 6.8165 13.6112 3.99792 -3.90075 7.11277 +622 1 16.8306 0.705066 9.59578 -7.6122 -1.79623 -7.44488 +623 2 16.785 18.3903 9.75048 3.18156 2.06447 -0.865929 +624 2 16.3719 0.843651 8.74144 5.4764 0.262409 5.10626 +625 1 6.12658 11.6826 8.3633 -3.5227 -13.2845 -7.84739 +626 2 5.19255 11.5559 8.64231 15.2704 -3.4985 -2.63712 +627 2 6.45331 10.8168 8.01189 -8.18375 16.1965 9.35276 +628 1 2.85137 8.68091 0.385463 -5.58051 9.89965 12.0536 +629 2 2.19225 8.31695 18.4611 -2.16592 -25.8024 -20.6889 +630 2 2.2971 9.35613 0.77772 10.4924 10.4953 14.3564 +631 1 10.1291 10.4583 6.52809 -2.44089 1.08082 5.72444 +632 2 10.551 9.78353 7.0828 -0.111445 0.581803 -4.14441 +633 2 10.6952 10.5682 5.75546 0.540532 -2.90301 -3.90698 +634 1 6.75412 15.726 6.57209 -8.13971 -2.30487 -2.02419 +635 2 7.24364 15.9641 7.36655 2.15693 7.18823 -0.87292 +636 2 6.8879 16.4298 5.90744 8.86888 -7.67267 7.00242 +637 1 6.43944 13.0908 5.62507 5.5957 4.80241 6.78236 +638 2 6.68766 13.9873 5.91055 -1.86537 -6.12454 -2.89892 +639 2 6.02344 12.6885 6.39583 0.545895 -2.8305 -0.33431 +640 1 16.7919 12.5477 9.81186 8.33998 7.78307 -15.4118 +641 2 16.959 11.947 9.07064 -2.3739 -7.40637 3.16023 +642 2 17.0566 13.4004 9.43565 -5.48117 -2.43007 10.0621 +643 1 6.08508 2.94496 2.79534 5.32525 -4.78467 20.7365 +644 2 6.22401 3.88181 2.60268 1.06349 -0.160394 -8.38338 +645 2 5.80007 2.47136 2.00522 -4.08992 3.93243 -8.80646 +646 1 10.8869 3.24711 3.28239 -4.40001 1.54122 -3.81905 +647 2 10.3919 4.04182 3.50512 -0.182415 -1.04618 4.274 +648 2 10.507 2.97693 2.43998 1.37333 -6.80979 -0.861155 +ITEM: TIMESTEP +40 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.77679 7.00681 17.9176 19.5781 -11.4355 -6.13067 +2 2 7.88289 7.04978 18.2154 -24.3238 4.20085 7.9494 +3 2 8.82569 6.20257 17.3924 1.80136 1.41546 -3.93969 +4 1 18.6608 8.28849 6.81179 -5.26854 6.47195 -37.0065 +5 2 0.259818 8.10211 5.87223 -9.20216 6.37217 14.1473 +6 2 0.533966 7.65898 7.28863 11.4703 -14.4857 21.9358 +7 1 8.44459 18.6539 6.84319 -15.0888 3.44445 3.75329 +8 2 9.31627 0.207433 6.52222 15.1831 4.47029 -4.67038 +9 2 7.87035 0.688968 6.45696 3.7806 -3.44044 1.26969 +10 1 6.57294 1.78151 11.6706 -30.0599 9.45416 18.0529 +11 2 5.79693 2.24632 12.0928 24.7239 -13.8096 -10.3139 +12 2 6.23894 0.879353 11.5248 3.88204 4.12095 -2.29502 +13 1 7.0611 5.68864 2.39703 8.93877 -14.6422 -9.86735 +14 2 6.49127 6.20844 2.93802 -15.3109 10.2002 23.1803 +15 2 6.88849 6.05122 1.53455 1.63853 6.11013 -15.8751 +16 1 16.2018 10.2111 16.0976 42.0151 -2.30245 8.02011 +17 2 17.1767 10.3828 16.1846 -31.1897 -9.90141 -8.38467 +18 2 15.8087 11.0308 16.3852 -12.3763 9.98735 1.02793 +19 1 10.6387 14.9527 2.33657 9.03987 18.5511 -2.17595 +20 2 10.545 14.5243 3.1949 1.96881 -4.62445 -0.461144 +21 2 11.2262 15.72 2.53493 -10.4825 -13.512 -5.5858 +22 1 17.1607 8.25027 10.5569 -10.4361 3.90862 15.3578 +23 2 16.8456 8.92829 11.1924 -0.168965 -8.85021 -9.39988 +24 2 17.9277 8.63713 10.1294 7.74511 3.00226 -1.55375 +25 1 14.7566 15.8542 16.4215 -9.50848 16.8449 -9.38304 +26 2 13.8265 16.1715 16.4278 14.8795 -5.02546 -3.6071 +27 2 14.9162 15.569 17.3232 -2.48975 -11.4773 7.52297 +28 1 12.1331 13.4103 0.48985 -10.556 -4.43922 -13.5861 +29 2 11.9475 13.3795 18.1761 8.0664 -0.863413 7.07636 +30 2 11.3865 13.8946 0.862316 6.65844 3.98247 10.4433 +31 1 9.29843 5.44761 4.00486 3.37284 8.34248 -28.0116 +32 2 8.80378 5.24143 4.78809 -8.97197 -9.15203 12.3932 +33 2 8.61542 5.51114 3.30134 8.62356 -3.76178 8.99247 +34 1 1.79678 4.17189 11.6321 9.86643 -30.5991 16.8051 +35 2 1.62878 5.09135 11.8205 -3.04918 18.6361 6.49963 +36 2 2.25792 3.77365 12.4221 -11.5809 11.2089 -24.12 +37 1 2.02425 6.80455 8.32417 0.209126 8.78432 0.0974623 +38 2 2.41895 7.33028 9.04952 -2.4595 -11.9319 -6.9206 +39 2 1.91003 5.89259 8.64365 4.06316 7.1017 -1.03524 +40 1 5.41039 4.42866 7.97545 15.1976 -3.31539 14.1613 +41 2 5.46063 3.46886 7.81834 -3.32316 3.28084 -1.43066 +42 2 4.8072 4.83488 7.36206 -13.6118 -1.04066 -17.9483 +43 1 3.27942 2.94296 17.507 14.649 -12.38 -13.2068 +44 2 4.01307 3.22765 16.9192 -12.2988 4.29907 8.19647 +45 2 2.92414 3.72569 17.9407 -4.7152 6.06254 1.98711 +46 1 7.44402 5.32718 6.09908 -2.23439 -3.56175 -18.7368 +47 2 8.08992 5.98284 6.3762 -3.15187 6.11466 20.9447 +48 2 6.88688 5.06352 6.84221 3.51936 -1.39652 7.32666 +49 1 9.78623 6.99393 11.9838 -8.59529 -1.09594 -12.3674 +50 2 10.3445 6.45759 11.4052 1.55365 1.23763 7.43723 +51 2 9.00985 7.18223 11.4209 7.62587 2.79809 7.26056 +52 1 14.0725 3.61727 8.08367 12.8617 -8.18347 36.7285 +53 2 14.0228 4.31343 7.45005 -3.4794 19.1063 -13.5046 +54 2 14.4179 4.02628 8.91908 -9.29791 -10.4076 -21.8094 +55 1 4.59231 17.2384 3.97449 0.493238 3.33808 0.649061 +56 2 5.51414 17.4776 4.03994 12.0557 0.622386 5.90157 +57 2 4.23063 17.8039 3.28947 -7.41249 -4.06804 -9.31956 +58 1 16.4721 16.5989 10.1846 -15.657 14.3962 29.6607 +59 2 15.672 16.8273 10.736 23.5631 -12.0212 -18.4682 +60 2 16.1719 15.9965 9.50314 -9.75188 -3.46964 -7.56259 +61 1 1.98052 4.85246 0.373619 -1.44601 4.98585 -7.77412 +62 2 2.7262 5.17853 0.894803 -2.15831 4.7879 6.78517 +63 2 1.59165 5.65237 -0.0264377 4.8265 -6.05414 -1.09652 +64 1 11.6431 13.3034 16.3099 -7.83069 14.4437 11.7005 +65 2 11.0472 12.5464 16.386 4.77345 -10.1552 -4.34879 +66 2 12.2516 13.1635 15.5747 -3.53477 -7.02177 -5.05796 +67 1 10.1531 11.0326 16.9094 -23.9188 11.6521 -2.01913 +68 2 10.5087 10.1543 16.8125 9.70699 -14.9542 1.17008 +69 2 9.18648 10.9213 16.8155 11.1855 0.742098 0.22461 +70 1 11.7413 17.4552 13.4621 -1.23374 28.315 3.5075 +71 2 12.4767 17.2116 12.8888 0.8966 -9.51431 -5.30227 +72 2 11.7922 18.439 13.4864 2.17346 -17.034 -0.823798 +73 1 6.40572 9.32656 12.214 8.55802 19.8904 20.5686 +74 2 6.90308 8.91303 11.5283 8.82473 -10.1612 -21.9185 +75 2 7.05175 9.94906 12.6124 -18.2049 -7.77814 -0.199089 +76 1 16.2334 12.8098 2.68826 14.0272 -12.5996 -1.63763 +77 2 17.097 13.226 2.50419 -12.4159 2.28924 0.929092 +78 2 15.5495 13.4898 2.7216 0.770652 8.50493 2.13384 +79 1 0.665645 12.593 5.91595 32.2246 4.40393 3.59492 +80 2 0.90587 12.5095 4.99041 5.40697 -3.98614 -5.66175 +81 2 18.3758 12.6087 5.91046 -34.4951 5.63016 -3.48792 +82 1 5.23151 16.431 18.4431 -16.7943 8.81872 -4.95242 +83 2 5.79594 15.7593 18.0508 10.3373 -8.32481 3.89376 +84 2 5.47944 16.6222 0.707356 8.36178 -5.19521 1.40492 +85 1 0.571414 7.67431 4.12619 2.94709 1.59491 -2.60127 +86 2 18.6158 8.07004 3.46977 2.09916 -2.88444 -0.00351913 +87 2 1.46322 7.94524 3.84829 -2.55586 0.342718 0.201417 +88 1 3.11705 8.93424 6.4998 54.1901 -7.8337 2.25484 +89 2 3.7667 8.5317 7.12157 -13.167 10.549 -15.4875 +90 2 2.28764 8.76575 6.88741 -36.769 -1.96533 12.6863 +91 1 7.28047 10.3297 16.2671 12.2744 -1.5589 -10.8048 +92 2 6.65751 10.5384 15.5688 -5.93087 0.719661 3.96859 +93 2 6.78418 10.1979 17.0822 -4.65586 3.14184 2.44827 +94 1 11.1311 1.01006 5.00872 -4.59838 3.25637 13.1063 +95 2 11.104 1.87564 4.56859 3.00456 -5.57579 -4.19999 +96 2 10.7195 0.375584 4.41788 -1.87117 -0.379426 -13.1931 +97 1 4.37947 2.77237 13.219 1.2209 -0.528365 -1.66794 +98 2 4.72737 3.08878 14.0495 2.85744 14.0767 5.60955 +99 2 4.20383 1.85536 13.4394 -3.83295 -12.6961 -6.71285 +100 1 8.38383 10.1509 1.80871 -12.6182 20.2791 -9.41543 +101 2 8.178 10.838 2.47049 7.2019 -6.44506 -5.42193 +102 2 8.73482 9.42727 2.30684 9.9898 -17.6863 11.9989 +103 1 10.4319 1.72481 15.5562 12.4011 -4.85254 7.43664 +104 2 11.3895 1.56158 15.4091 -17.4954 3.73262 -0.131687 +105 2 10.062 2.13812 14.7716 6.37582 -0.463351 -11.2945 +106 1 2.70803 12.8564 7.7877 0.947466 12.6679 0.63847 +107 2 3.18684 13.6562 7.51328 0.350127 -6.04869 0.642024 +108 2 1.99719 12.778 7.13709 0.576803 -6.26493 0.417134 +109 1 3.70343 11.6943 5.19413 20.2082 20.004 0.0632986 +110 2 3.58824 10.8286 5.55511 -6.2763 -16.1433 9.0068 +111 2 3.08304 11.8089 4.48497 -14.3756 -1.22762 -7.56914 +112 1 6.79775 14.44 16.9261 12.4025 3.68508 -3.36544 +113 2 7.76361 14.3574 16.912 -9.58328 3.53086 0.838276 +114 2 6.54478 14.7426 16.0399 -3.94857 -4.38541 1.40645 +115 1 14.2011 14.5459 3.3522 -3.08566 -2.84615 -1.00806 +116 2 13.6596 15.3308 3.14384 3.83224 -9.07839 4.89455 +117 2 13.7292 13.9763 3.99269 1.14293 11.3016 -6.48612 +118 1 8.39096 18.1361 16.0337 -32.316 13.1552 1.22555 +119 2 8.83502 17.3455 16.3332 22.4875 -6.85104 -0.859562 +120 2 8.9267 0.219511 15.6905 18.196 -4.39201 7.01778 +121 1 4.72714 1.63535 4.92703 -26.6842 -20.3158 26.1173 +122 2 3.8064 1.92851 4.99525 4.72714 3.40068 -1.69015 +123 2 5.07003 2.08002 4.18139 17.9323 21.4409 -28.6349 +124 1 14.9964 12.7123 16.4352 -4.22015 -14.1687 -30.4934 +125 2 14.5029 13.21 17.0522 -6.30453 18.4993 32.9687 +126 2 14.3164 12.5754 15.7407 23.1427 -3.84454 1.0347 +127 1 15.7385 18.4508 16.8675 -13.9243 -22.2803 -23.7862 +128 2 16.4074 18.4637 17.529 20.9098 4.79862 21.1737 +129 2 15.5806 17.4953 16.7298 -7.09236 11.271 1.12369 +130 1 1.21817 1.19055 16.5653 11.7565 -7.97186 -17.2906 +131 2 1.96844 1.77109 16.7379 1.96571 4.11248 6.40071 +132 2 0.658106 1.26508 17.3256 -9.62795 7.29392 16.1709 +133 1 18.134 4.50826 15.9251 -3.15057 6.2034 16.9599 +134 2 18.3539 4.06683 15.1192 3.29697 -9.24478 -15.9855 +135 2 0.215105 4.3469 16.5346 0.451532 1.5183 -0.00159427 +136 1 12.2559 16.9635 16.13 9.81693 16.417 -30.969 +137 2 11.5335 16.7255 16.6761 -27.6315 -15.1383 17.2649 +138 2 11.8852 17.008 15.2138 11.4543 -2.176 15.2032 +139 1 16.0072 2.53826 18.0715 2.86853 -7.51147 -8.26075 +140 2 15.4847 3.23875 18.4474 -1.55266 16.6686 8.62869 +141 2 15.8031 2.59593 17.1292 0.710765 -2.58084 -2.04371 +142 1 6.70782 13.8427 10.2201 -0.679857 -3.70625 -19.7607 +143 2 6.50134 13.5235 11.1067 -0.321862 -5.5215 0.0793921 +144 2 6.59662 13.1168 9.5703 -2.40279 4.60459 14.5526 +145 1 10.136 18.3381 2.74267 -18.0567 -22.0341 20.6824 +146 2 10.1719 0.451126 2.17508 1.85432 15.9621 -15.8725 +147 2 9.21984 17.9907 2.65838 20.6262 7.0183 -5.07627 +148 1 3.02443 17.7208 6.1026 17.1013 10.0229 -4.66436 +149 2 2.15568 17.711 5.71196 -13.0363 -3.14036 -7.80794 +150 2 3.59824 17.9918 5.35649 -4.18715 -9.59785 14.6662 +151 1 12.576 16.8948 8.01086 19.6337 5.92584 -6.52436 +152 2 11.8143 16.3513 7.79321 -8.3204 -4.9503 8.18666 +153 2 12.4158 17.4227 8.81259 -8.93553 -1.00079 -7.85288 +154 1 14.8883 15.2954 8.22088 18.3997 -23.9506 8.44323 +155 2 14.185 15.9366 8.136 -10.7922 9.32905 -8.87486 +156 2 15.3949 15.2296 7.38647 -11.857 13.9652 6.76292 +157 1 17.682 18.2494 0.348905 -7.91474 13.422 2.87656 +158 2 18.5411 17.7865 0.321045 -1.05993 10.3639 -2.93184 +159 2 17.7527 0.554981 0.612143 9.7328 -21.6142 -4.56589 +160 1 0.864553 10.4271 1.36107 38.8853 37.5027 -14.379 +161 2 0.108953 9.99831 1.68821 -41.9718 -23.1906 9.82059 +162 2 0.582253 11.2112 0.83245 0.481516 -18.0373 9.72219 +163 1 1.69239 12.2275 3.35367 -4.8948 -13.153 3.57872 +164 2 1.37753 11.4769 2.79371 7.82838 19.3971 -0.83705 +165 2 1.72119 13.0511 2.84994 -1.71551 -5.72989 -9.02345 +166 1 0.593488 17.2339 4.88925 5.54216 -9.27995 13.1842 +167 2 18.6577 17.9974 4.73698 -0.720643 -6.26101 15.0882 +168 2 0.46443 16.7935 5.76992 -5.72363 16.5902 -22.8723 +169 1 1.11371 0.949119 9.43078 -14.7072 -12.8067 -15.4602 +170 2 1.29442 0.455313 10.245 -0.545661 8.99323 2.98013 +171 2 0.250893 0.599212 9.12975 16.3522 9.05079 5.79158 +172 1 16.7438 2.34594 13.2927 -5.57812 -16.9062 26.8121 +173 2 16.8801 2.6271 12.4058 4.66444 4.54161 -27.0891 +174 2 16.4868 1.39796 13.2842 6.06262 14.3342 0.102967 +175 1 2.62374 15.8311 12.1325 -18.0747 14.04 -25.4855 +176 2 3.15014 15.3809 12.7666 13.9506 -11.3972 18.0386 +177 2 3.07511 15.7224 11.2774 1.07994 -2.68321 4.96368 +178 1 16.4243 15.6576 6.03755 15.9104 -4.34147 -2.36376 +179 2 17.3476 15.7161 6.33483 -8.235 -6.85341 4.18965 +180 2 16.3427 16.413 5.44101 -7.92512 0.157724 -1.18513 +181 1 5.79129 5.09168 11.8004 -4.72983 -0.0241771 3.34223 +182 2 5.24592 5.67928 12.3598 8.87085 -1.40185 -4.45321 +183 2 5.33436 4.24005 11.794 -1.89173 5.24027 0.81451 +184 1 15.1611 4.86757 0.757741 -10.8083 7.02962 -6.60621 +185 2 15.185 4.56786 1.66832 -2.59424 -2.50065 9.27943 +186 2 14.3347 5.37902 0.687967 11.9305 -6.73266 -3.44958 +187 1 16.3215 16.3801 2.08305 3.66808 -22.0917 28.3334 +188 2 16.2883 16.7145 3.0131 -8.2177 -1.24054 -23.9705 +189 2 16.5228 17.1161 1.52724 6.03518 21.1991 -10.8898 +190 1 0.258418 4.84833 3.80491 9.83943 -33.1452 17.0376 +191 2 0.435143 5.7654 3.92096 2.60191 31.4745 -0.643169 +192 2 0.932226 4.39489 4.35318 -12.3014 6.6918 -13.6862 +193 1 2.96829 15.0617 15.1396 -6.44278 -4.84309 -5.22724 +194 2 2.79942 14.7982 16.0602 -0.108783 -2.99279 -5.19286 +195 2 2.41643 15.8476 15.0194 7.7594 2.37019 3.88633 +196 1 1.13965 14.6405 9.53256 -35.9747 -40.3241 22.6064 +197 2 2.06314 14.7027 9.49112 43.1319 12.9068 -8.07313 +198 2 1.0594 13.7772 10.0119 -9.44904 20.5678 -15.2205 +199 1 13.5675 16.5961 11.5382 5.93785 -23.7105 -2.52771 +200 2 13.3768 17.2545 10.8786 -7.41053 16.3631 -3.48345 +201 2 13.1856 15.7884 11.1314 1.00946 8.65797 10.7521 +202 1 4.66618 1.4643 0.77663 11.7421 5.19522 -12.5382 +203 2 4.19094 2.00712 0.127209 -4.75679 -3.07286 5.52347 +204 2 4.08138 0.751582 1.04859 -6.60629 -1.36494 5.43578 +205 1 1.44472 18.5589 11.8552 5.89014 -29.5111 2.70443 +206 2 1.28184 0.411827 12.6654 0.0657759 4.1157 4.72514 +207 2 1.66959 17.6355 12.1243 -0.811151 21.0135 -2.36357 +208 1 11.5239 10.1243 4.0099 -6.2394 6.26334 5.03821 +209 2 11.225 10.535 3.18075 6.07738 -4.97061 3.39644 +210 2 12.4891 10.1836 4.01184 1.61922 -2.52467 0.807021 +211 1 8.27885 12.1614 3.71144 8.13123 -6.41358 -26.5436 +212 2 9.10665 12.5897 3.97429 -2.42085 2.52867 6.94663 +213 2 7.68553 12.1691 4.45091 -10.6399 7.25218 24.1014 +214 1 14.4389 4.03262 3.28382 -1.54769 2.04788 0.687462 +215 2 14.9998 3.98927 4.07922 -0.140352 3.9435 -3.93632 +216 2 13.6855 4.60992 3.49399 3.24138 -5.01437 4.30138 +217 1 5.6049 1.66195 7.51556 2.43321 19.3851 -35.7094 +218 2 4.99817 1.05358 7.93111 -11.2062 -8.09843 6.71806 +219 2 5.29033 1.73413 6.56196 15.7086 -7.98236 30.9511 +220 1 17.8679 1.11465 4.8662 -8.84521 -11.3875 -0.414623 +221 2 18.5938 1.34898 4.28573 7.92092 9.45731 -1.66923 +222 2 17.9348 1.63294 5.67672 2.41874 4.31495 -1.38437 +223 1 6.82183 9.41821 4.49596 0.331068 -0.81956 4.69879 +224 2 6.92763 9.68813 5.42975 0.55668 -5.9518 -10.6641 +225 2 7.69076 9.13696 4.17138 2.49623 1.53594 7.84385 +226 1 2.6692 14.9191 1.96889 -13.7427 -15.0981 33.3863 +227 2 3.22272 14.7135 2.75628 -3.53882 5.4164 -17.9931 +228 2 3.23582 15.271 1.30455 16.0902 7.51076 -16.3339 +229 1 17.3236 12.914 13.1856 6.20451 10.459 -3.7314 +230 2 16.5162 13.3803 13.3896 -16.2035 -4.78456 4.03007 +231 2 17.8657 13.6659 12.9192 5.22743 -7.26423 -1.93052 +232 1 14.957 10.5619 1.40158 33.4378 15.8576 14.4167 +233 2 15.5687 11.2535 1.77718 -16.3935 -17.8486 -10.6273 +234 2 14.0947 10.9454 1.47451 -15.7071 3.57407 -1.68856 +235 1 5.70225 6.80052 4.56184 6.57688 14.9147 -7.26545 +236 2 6.13296 7.68472 4.64206 -12.0226 -12.483 -2.28626 +237 2 6.28869 6.17268 5.00191 2.5554 2.13057 5.94298 +238 1 8.01258 8.29623 10.2593 -8.54796 -9.21297 9.02749 +239 2 8.56841 9.06789 10.0886 3.62647 -1.62136 -15.6888 +240 2 7.62542 7.94814 9.4343 7.03713 6.69092 4.95874 +241 1 13.441 18.4149 5.75957 4.19405 2.302 -13.2138 +242 2 12.6243 0.255994 5.52243 8.89948 -2.22339 5.88848 +243 2 13.1991 17.7887 6.44621 -5.69407 0.108635 9.70575 +244 1 0.157493 2.61527 0.174457 -9.01339 -22.8294 -0.321401 +245 2 17.938 2.88173 18.4446 6.58659 5.28303 7.29983 +246 2 0.732894 3.35773 0.380844 -2.17088 12.8237 -3.11298 +247 1 12.7457 11.0391 9.7485 36.4778 -29.6492 25.4167 +248 2 11.881 10.9734 9.40839 -39.1103 -1.43989 -11.0388 +249 2 12.9187 10.1217 10.0968 -0.290925 20.2268 -9.99681 +250 1 0.740308 12.1745 11.0603 -22.9837 8.27774 -1.01284 +251 2 18.4139 12.2368 11.1424 7.83285 -3.43363 -6.48653 +252 2 1.04445 12.5328 11.8929 13.1768 -0.7817 9.81141 +253 1 5.09631 7.29496 13.4329 -5.02176 -6.40528 2.12919 +254 2 5.65923 7.87015 12.9013 0.281799 7.42737 5.37855 +255 2 5.54275 7.21467 14.2893 3.22018 -2.41867 -5.38403 +256 1 1.21307 6.88521 11.8471 45.2055 23.2855 19.4361 +257 2 0.504281 7.33909 11.418 -17.6401 7.5893 -9.966 +258 2 1.85566 7.62216 12.1147 -28.9146 -29.9066 -6.84092 +259 1 15.4951 9.58282 12.318 3.7565 -9.08444 -2.54037 +260 2 14.9885 10.3731 12.1762 -1.60608 19.4691 -5.65324 +261 2 15.197 9.26603 13.1641 1.66558 -4.92983 10.8479 +262 1 16.5876 12.7654 5.4778 8.29992 -4.99789 29.9812 +263 2 16.3841 13.7077 5.58453 -1.61151 1.51391 -8.42869 +264 2 16.4534 12.5134 4.57091 -6.79319 5.2662 -20.9737 +265 1 6.24519 9.93185 0.0511849 19.8307 -8.34124 26.5163 +266 2 5.62326 10.391 0.623031 -8.96333 4.37615 -1.09153 +267 2 7.04636 9.86115 0.632167 -14.2701 4.68407 -14.2447 +268 1 12.3094 6.10151 4.07154 29.4526 9.60181 -18.9544 +269 2 12.3581 6.67925 3.27122 -7.72489 -2.14158 19.4346 +270 2 11.4533 5.70734 4.07903 -24.5921 -5.49884 -2.8127 +271 1 0.238725 12.7856 0.183979 8.51406 3.08383 0.253195 +272 2 0.144933 13.4932 0.833619 -6.86037 1.22763 2.8825 +273 2 18.4214 13.096 18.0418 -3.66036 2.31192 -5.9902 +274 1 3.70956 18.598 8.57987 -8.91795 8.796 11.4474 +275 2 3.55449 18.0356 7.80833 -3.96611 6.10323 -0.149317 +276 2 2.8446 0.378518 8.78385 11.2365 -8.2841 -4.38951 +277 1 7.48876 17.3305 4.49636 -9.17434 -25.7083 -0.449464 +278 2 7.67261 18.2518 4.49855 7.01126 32.4538 5.60223 +279 2 7.56532 17.0943 3.57389 -1.71949 -1.63571 -7.00131 +280 1 9.24209 17.1007 12.2607 -0.0867103 -4.31389 -13.5747 +281 2 9.30622 16.4126 11.5797 -4.40084 -0.983353 3.37399 +282 2 10.1228 17.1279 12.6444 4.44927 1.46684 7.86514 +283 1 13.3362 12.9421 7.98122 6.55916 41.1429 -16.6734 +284 2 13.3796 12.1892 8.55526 4.57885 -11.5398 14.8452 +285 2 13.9495 13.647 8.31623 -8.21726 -16.9651 -6.13203 +286 1 14.9343 2.98184 15.3399 -18.8859 -3.08059 15.3623 +287 2 14.3306 2.22694 15.2091 8.05839 6.56319 -1.64083 +288 2 15.5611 2.99492 14.6188 6.00199 -3.60128 -9.94013 +289 1 9.8611 15.5568 16.9864 -5.18568 1.15062 7.50023 +290 2 10.3014 14.7282 16.7357 2.8278 3.85059 0.776615 +291 2 9.42894 15.4199 17.8518 3.24739 -0.30663 -9.25648 +292 1 11.3089 8.34774 16.5637 -8.99518 -4.25182 3.40254 +293 2 10.6351 7.93491 15.9913 5.93093 -1.15278 9.90769 +294 2 11.3777 7.78039 17.3602 -0.876032 6.75541 -11.8921 +295 1 3.86263 18.1743 16.7605 8.31608 -24.0238 3.67333 +296 2 4.34809 17.526 17.3016 -5.03788 -1.4921 -11.4176 +297 2 3.91859 0.291346 17.3034 -3.84782 28.4328 8.21839 +298 1 2.18675 4.1526 8.92206 -24.1698 7.19476 -17.4672 +299 2 3.08777 4.02084 8.66345 19.2563 -3.88604 2.84364 +300 2 2.11989 4.14607 9.87269 6.11123 -7.11558 17.6044 +301 1 9.878 10.3743 9.69372 5.53967 -18.4491 14.0185 +302 2 9.43572 11.1423 9.3425 -1.35277 14.796 -0.820696 +303 2 10.0526 10.4842 10.6451 0.294207 2.81912 -6.3598 +304 1 9.67606 0.861397 10.8616 12.1631 -0.119776 7.34561 +305 2 9.24662 0.0503119 11.2005 -2.60905 7.79605 -9.27605 +306 2 9.17358 1.27941 10.1433 -7.66403 -7.87567 2.43043 +307 1 9.19351 15.1133 10.2188 11.11 2.94282 0.236533 +308 2 8.72034 15.7288 9.64731 -2.95318 7.0206 -0.021652 +309 2 8.61234 14.3559 10.3013 -9.273 -0.749783 0.810803 +310 1 0.983709 9.49699 10.2982 -74.1988 19.4185 4.2569 +311 2 0.893433 10.4494 10.5162 13.7438 -13.7231 -2.84852 +312 2 1.86549 9.26486 10.2468 58.3196 -6.52918 -3.90093 +313 1 16.9084 4.83943 8.1598 4.06942 21.6595 -28.8412 +314 2 16.3724 5.61591 8.36865 -1.41178 -4.09344 3.51719 +315 2 16.8393 4.26054 8.89216 -0.699807 -17.3102 23.1105 +316 1 14.7125 14.7098 0.257213 21.3866 7.73012 -2.74727 +317 2 15.2455 15.0698 0.987096 -5.24332 1.02996 -2.3964 +318 2 13.934 14.3364 0.654485 -15.8904 -6.61515 6.72623 +319 1 3.61962 11.0361 9.55343 7.54802 -1.42323 12.4812 +320 2 3.62776 11.3571 10.4773 -0.544226 1.54555 -6.56144 +321 2 3.18313 11.7186 9.01674 -3.18494 -0.813089 -1.4949 +322 1 11.1481 10.7794 1.3867 -18.0125 -13.9714 2.13506 +323 2 11.5419 11.6189 1.17487 5.50703 16.2749 -10.1623 +324 2 10.2377 10.7815 1.02242 13.9743 0.382042 6.15217 +325 1 13.1644 7.14571 12.7934 28.1674 11.2254 -0.0108115 +326 2 14.1505 7.05998 12.7803 -16.3048 -3.53009 2.57838 +327 2 12.835 6.25234 12.9024 -6.40061 -9.363 -1.95696 +328 1 9.62034 1.87073 0.979069 -6.9897 -0.645983 -14.1021 +329 2 8.86926 1.41829 0.528843 9.90899 13.9476 5.87182 +330 2 10.1257 2.37739 0.312436 -3.40486 -11.198 4.68953 +331 1 10.6367 13.5403 4.62088 -14.2461 -11.7796 -9.34504 +332 2 11.3649 12.9086 4.64313 9.4379 4.41524 3.81629 +333 2 10.614 13.9519 5.48444 4.98914 7.07 10.6976 +334 1 14.3951 1.77229 10.9373 11.882 -13.8992 0.14286 +335 2 15.2529 1.46692 10.5904 -8.80209 -5.09491 0.192719 +336 2 14.4998 2.72321 10.9422 -3.89457 8.74507 -1.42899 +337 1 14.6035 12.2778 11.6732 8.28457 -2.47972 34.5189 +338 2 15.3822 12.4706 11.1386 -1.8445 -1.29245 -12.2333 +339 2 13.8238 12.1274 11.1597 -9.6117 -2.29221 -24.4043 +340 1 8.21682 5.05944 9.82725 33.2235 -12.7421 -22.1109 +341 2 7.50249 5.31613 10.3805 -26.8995 -2.6371 14.604 +342 2 8.16278 4.09579 9.61432 -6.39419 19.305 4.57693 +343 1 1.57178 16.8746 18.3696 -12.5949 -28.7752 19.8992 +344 2 1.95856 17.2997 17.6256 12.4489 12.7929 -23.944 +345 2 1.61191 15.9133 18.1414 3.74732 18.7705 7.54273 +346 1 1.50483 17.2622 15.3369 -31.2805 -0.211241 0.372367 +347 2 1.56428 18.1715 15.7008 -8.02099 -13.4799 -3.86937 +348 2 0.550545 16.944 15.3287 29.8388 16.9503 2.40621 +349 1 3.67189 5.70682 6.10259 2.52977 5.35962 -6.45813 +350 2 3.10512 6.24939 6.65687 -5.8484 1.84291 7.09291 +351 2 4.11645 6.33532 5.504 1.86189 -8.61654 4.18176 +352 1 12.4205 9.46682 14.1922 0.00765934 6.29699 5.01976 +353 2 12.7713 8.66673 13.7826 1.27338 -5.49384 -0.333278 +354 2 12.2037 9.20626 15.0998 2.51081 -2.42178 -0.168732 +355 1 4.04257 15.2822 6.8914 -27.6779 4.92775 8.06061 +356 2 3.56316 16.0906 6.63798 2.42102 -8.57509 -1.16647 +357 2 4.95231 15.5118 6.77617 25.3206 1.78005 -4.31003 +358 1 0.630616 8.59357 14.9621 0.0534875 13.3347 6.63524 +359 2 0.475879 9.54739 15.0951 0.802494 -5.58418 -0.636111 +360 2 1.32488 8.5708 14.2996 4.58301 -1.27906 -6.75903 +361 1 12.9988 8.28033 10.3217 -21.3611 19.4324 1.5895 +362 2 13.6573 7.74741 9.88515 12.8548 -10.016 -2.83384 +363 2 12.9714 7.9897 11.246 0.968107 -4.04745 -5.09921 +364 1 15.3184 7.7322 3.54707 4.18654 -9.90345 10.9868 +365 2 14.6375 7.17364 3.22195 -21.9236 0.488691 -25.4272 +366 2 15.542 7.2045 4.31452 16.9904 15.0521 14.7627 +367 1 17.298 6.68564 0.0426033 13.9193 -14.0885 -0.920406 +368 2 16.8642 5.82471 0.139777 0.0396094 5.05794 2.76644 +369 2 16.6003 7.28204 18.4358 -17.9105 11.3609 -4.38582 +370 1 8.85442 6.93876 7.83202 25.5204 20.9839 -12.9835 +371 2 9.78415 7.28149 7.87459 -21.3181 -5.86923 -3.23496 +372 2 8.81067 6.25344 8.49096 -5.61401 -13.4392 14.4413 +373 1 12.3763 0.596552 1.22002 -1.17453 2.99561 6.82033 +374 2 13.3385 0.528874 1.30915 -5.26207 -0.953155 0.827968 +375 2 12.0852 0.273415 0.369127 5.54968 -2.26078 -4.64309 +376 1 5.63283 15.1348 14.5573 -11.4131 -7.08845 -3.56826 +377 2 4.66833 15.2302 14.6984 9.61439 -4.03287 3.27369 +378 2 5.92452 15.9751 14.1944 7.77409 8.39082 -1.96781 +379 1 3.86657 6.44559 1.75085 5.80409 -14.6499 1.98717 +380 2 3.55249 7.31671 1.4889 -5.45171 9.45984 0.647045 +381 2 4.14269 6.4981 2.68117 -5.39897 6.08822 -6.8935 +382 1 3.91507 11.6157 12.3486 -13.4135 -1.42429 5.74998 +383 2 4.7693 12.0145 12.538 6.44699 -0.479912 -1.2837 +384 2 3.27735 12.1325 12.8813 7.77399 -7.15276 -11.5357 +385 1 5.36262 3.86651 15.8768 12.1389 -59.3419 -3.52329 +386 2 6.1064 3.19888 15.7551 -26.8485 22.8054 1.66706 +387 2 5.75212 4.71249 15.8089 15.627 34.646 -1.2618 +388 1 14.3819 10.2457 4.44716 -17.5064 5.46907 41.0935 +389 2 14.5449 9.71992 5.26671 -1.94493 10.8322 -14.5796 +390 2 14.8723 9.82528 3.76702 14.2142 -16.5996 -23.0963 +391 1 7.82031 17.402 9.18196 15.4978 -20.6961 5.52716 +392 2 6.95708 17.6159 9.5372 -6.73409 6.75657 -1.79958 +393 2 8.0438 17.9374 8.41052 -8.48575 5.6988 -1.01071 +394 1 4.52697 14.5011 3.99561 -1.64824 1.80571 -15.4173 +395 2 4.43911 15.4257 4.28139 2.0309 -4.99506 3.13673 +396 2 4.3827 13.9072 4.73582 -0.0495062 -0.930109 11.2178 +397 1 14.2192 7.41869 15.785 -17.5888 -3.59777 -10.979 +398 2 15.1626 7.35697 15.6947 20.631 -1.7403 -3.62609 +399 2 14.073 7.80524 16.6426 0.667235 5.42077 11.7037 +400 1 2.9565 18.2605 1.91108 1.19197 -18.909 -26.3864 +401 2 2.43337 17.7432 1.2423 11.354 8.34367 16.4878 +402 2 2.37308 0.276014 2.2689 -15.3488 13.3111 9.03739 +403 1 8.00359 1.60253 4.55907 -38.5212 -7.91491 7.83452 +404 2 7.38229 2.10405 3.99193 12.1921 -3.74558 1.60605 +405 2 8.88232 1.74243 4.26439 24.0023 10.0694 -13.3902 +406 1 2.4736 14.1336 17.6839 19.5549 7.85258 6.07398 +407 2 1.90347 13.5339 18.1719 -6.00167 -6.95039 -0.586477 +408 2 3.38553 13.9045 17.9683 -9.72011 -2.72883 -0.373401 +409 1 0.820064 1.73894 13.8888 -18.5285 5.33114 2.4032 +410 2 0.803771 1.49328 14.8397 -2.66487 6.43341 -16.8821 +411 2 18.5531 2.02517 13.6233 21.0072 -9.49287 13.5993 +412 1 4.44957 0.0409644 13.9204 -25.6038 8.03756 8.31677 +413 2 5.34611 18.3721 13.8825 17.1601 -8.5878 1.82821 +414 2 4.09536 18.4705 14.8092 8.9848 -0.155186 -10.4675 +415 1 7.11939 0.665063 18.3496 37.4596 -16.3367 -22.9959 +416 2 7.39046 0.248229 17.4868 -7.59422 10.3961 22.0522 +417 2 6.17976 0.73857 18.3349 -24.6121 7.91301 3.99406 +418 1 16.0679 18.4255 14.0033 46.948 4.07246 14.5496 +419 2 15.1925 18.2569 13.7481 -41.7006 -8.82757 -2.39817 +420 2 16.1514 18.46 14.9783 -11.5795 5.15321 -10.1321 +421 1 10.0899 4.51466 16.2755 46.1692 31.6348 -9.79269 +422 2 11.0262 4.80528 16.0633 -26.3332 -3.27592 13.4521 +423 2 10.217 3.58436 16.3451 -11.2214 -29.3564 0.661634 +424 1 15.916 17.7977 4.41903 32.6965 1.49817 -6.30174 +425 2 16.457 -0.0326327 4.45612 -4.70593 -7.03645 1.74937 +426 2 15.0663 18.0576 4.73092 -30.5769 8.16516 8.13282 +427 1 7.01211 17.4116 13.808 -11.1093 -0.0306798 -7.53718 +428 2 7.48321 17.731 14.5797 1.71822 -1.35338 6.01299 +429 2 7.70771 17.2257 13.1599 -0.832239 2.47859 1.40448 +430 1 13.2731 6.49483 6.63036 5.49864 12.0855 21.8831 +431 2 14.0036 7.1367 6.53142 -6.95912 -13.4785 -6.50558 +432 2 12.9191 6.26998 5.7719 1.78547 5.07661 -13.1828 +433 1 7.78873 2.35817 9.26787 13.6578 7.92928 32.9359 +434 2 7.26595 2.28464 10.098 4.41261 -4.66671 -14.4408 +435 2 7.24114 2.08424 8.54668 -18.4281 -7.28868 -15.4379 +436 1 15.1807 14.8213 13.6836 12.0158 -14.5979 1.51453 +437 2 15.023 15.1631 14.5679 -5.44227 3.64048 5.06686 +438 2 14.7818 15.3898 13.0312 -8.03448 9.52233 -3.65179 +439 1 9.37687 8.31604 3.76928 5.34304 4.19186 5.02399 +440 2 10.2244 8.59911 4.15846 -6.46746 6.21109 -7.45595 +441 2 9.38739 7.36131 3.86692 -0.369722 -6.10407 -0.56198 +442 1 17.7826 13.5587 16.3931 -18.259 -13.3606 7.93732 +443 2 16.8564 13.2543 16.3515 3.23179 3.05811 2.18424 +444 2 17.7493 14.412 15.956 6.45918 8.6709 -4.68033 +445 1 4.96945 10.6182 2.7671 -20.0352 21.3698 -14.9929 +446 2 5.67156 10.2863 3.30832 14.7689 -7.42384 15.9186 +447 2 4.73305 11.5 3.12196 4.54065 -18.1741 -2.81522 +448 1 3.75186 8.34553 10.1595 -2.54049 11.5371 -18.7835 +449 2 3.83158 9.28658 9.87851 -1.62744 -10.9109 6.60301 +450 2 3.69687 8.33176 11.111 2.12623 4.07512 13.0596 +451 1 16.0105 7.02075 6.14683 -8.93467 17.9282 -2.69417 +452 2 16.8191 7.42843 6.45697 9.04966 6.41713 2.22097 +453 2 16.1641 6.09023 6.1704 3.21598 -21.4167 -2.94797 +454 1 15.1148 7.07457 9.06702 4.51295 -11.3361 21.5265 +455 2 15.7278 7.43111 9.72685 3.64545 -0.886375 -6.04752 +456 2 15.1684 7.6713 8.33808 0.281889 14.352 -20.2518 +457 1 6.32562 13.0044 12.7823 3.64263 -12.4915 -10.2251 +458 2 7.18031 12.5985 13.0233 -9.44077 2.88231 5.28619 +459 2 6.10277 13.6925 13.4113 4.07235 10.5841 12.4872 +460 1 12.13 4.50388 13.0978 -23.9143 -18.2098 -29.5576 +461 2 12.2018 4.66005 14.0386 -4.52664 -3.61945 12.4396 +462 2 11.31 3.95423 12.8708 29.5104 21.9629 17.7949 +463 1 11.3628 8.1671 7.89263 -5.63688 4.26156 -3.21905 +464 2 12.0486 7.63378 7.48497 5.26632 -9.68169 -9.18733 +465 2 11.6596 8.25059 8.79652 3.08614 3.11673 13.4283 +466 1 17.1728 10.8467 7.48683 -9.78257 9.61375 -3.53187 +467 2 17.8082 10.1926 7.21604 13.2987 -16.4259 3.23364 +468 2 17.1151 11.4269 6.71399 -11.2446 1.98681 4.69156 +469 1 5.26156 18.1118 11.0164 11.279 0.780011 3.76881 +470 2 4.63029 17.9037 11.706 -3.79608 -1.61163 6.00067 +471 2 4.75114 18.4846 10.3039 -10.5863 -2.03901 -14.6626 +472 1 7.60927 17.5116 1.80376 -12.2084 0.332405 -16.0787 +473 2 7.73547 16.6894 1.27511 4.49641 20.7738 7.60921 +474 2 7.29137 18.2078 1.17993 10.7818 -15.1152 7.96202 +475 1 1.93242 12.9038 13.5907 -11.1009 -8.62515 -2.91716 +476 2 1.44204 12.3193 14.1878 -0.742257 0.132846 -0.79095 +477 2 2.14259 13.6778 14.1103 6.96653 11.7909 8.84583 +478 1 9.6349 6.79099 14.8483 -7.90933 -4.5792 7.57822 +479 2 9.76837 5.84646 15.0736 0.917781 12.494 -4.6794 +480 2 9.97866 6.97841 13.9703 0.736717 -7.57275 -8.26148 +481 1 15.2733 4.3257 10.7584 -18.0594 -0.89979 -6.45033 +482 2 16.1458 3.96681 10.9687 3.533 12.3702 4.36819 +483 2 14.9475 4.94569 11.4317 15.7147 -3.56113 0.605423 +484 1 11.2438 6.16931 0.179082 0.0277951 -2.16566 -3.90965 +485 2 11.3357 5.30361 18.4317 14.8036 -12.0621 -1.88578 +486 2 10.2956 6.2638 0.1816 -11.5861 14.503 2.02073 +487 1 0.0439986 11.3816 15.0585 -6.49496 4.09431 2.20477 +488 2 18.034 11.5578 14.353 7.75523 3.54925 4.26198 +489 2 -0.111373 12.1024 15.7029 3.25408 -7.01329 -10.5532 +490 1 7.06114 9.23722 7.26386 23.5376 12.3273 -0.106793 +491 2 6.50127 8.56776 7.63843 -10.2441 -19.5548 5.03643 +492 2 7.97426 8.90952 7.38371 -13.166 2.65106 -3.29749 +493 1 18.3483 15.3728 12.3401 -6.10947 1.64082 -0.490965 +494 2 0.640544 15.4003 12.1341 13.3619 2.30286 0.418231 +495 2 17.9315 15.8707 11.6253 -4.70162 -1.66258 -3.35097 +496 1 16.5284 4.37134 5.23872 23.865 15.8443 -24.0922 +497 2 16.795 4.23475 6.13242 -1.17196 -10.8972 27.7735 +498 2 17.3848 4.63349 4.80865 -25.3878 -11.1359 -1.24016 +499 1 17.7266 3.13043 10.7284 -15.1505 -16.4799 -4.03799 +500 2 -0.0205156 3.31599 11.0266 10.8372 -1.61224 -0.261482 +501 2 17.686 2.21262 10.3629 5.98361 15.5222 5.29053 +502 1 12.2768 0.00077952 10.1229 -5.39949 -11.0736 -0.564535 +503 2 11.3994 0.337416 10.3512 -3.44242 -0.519791 1.58275 +504 2 12.8621 0.740723 10.2534 12.1364 13.942 1.61795 +505 1 10.3933 9.78571 12.4371 -17.696 -6.66554 -9.33286 +506 2 11.04 9.8019 13.1479 9.02187 0.111511 2.28178 +507 2 10.1583 8.84624 12.3274 6.95171 5.58218 -0.582165 +508 1 0.583846 2.83323 7.01904 8.81732 -31.8654 7.83245 +509 2 0.599611 3.49885 7.68934 -3.58556 22.6003 9.07619 +510 2 0.952398 2.07883 7.51841 -6.10214 6.37924 -11.0018 +511 1 0.367433 15.2949 6.92522 -4.7012 3.61818 34.4112 +512 2 0.558547 14.7156 7.70153 -1.71176 22.246 -5.06421 +513 2 0.60814 14.7658 6.19753 10.4713 -26.0103 -27.8181 +514 1 17.0409 7.00624 15.2099 -22.5014 1.92016 -1.24665 +515 2 17.7387 7.65639 15.0691 10.2085 -5.07189 3.59706 +516 2 17.3996 6.21947 15.6455 8.09739 1.82665 -3.45815 +517 1 9.08645 12.4582 8.07298 60.2845 4.68897 0.226728 +518 2 9.45122 11.8173 7.41895 -17.2892 5.38378 7.41181 +519 2 8.16079 12.445 8.11596 -46.4448 -7.25102 -10.4423 +520 1 1.26434 1.84534 2.97351 6.14985 -4.32801 10.6126 +521 2 0.602074 2.03133 2.30849 -1.31532 11.5451 -8.74279 +522 2 1.61884 2.681 3.33622 -3.80121 -10.2767 -5.51985 +523 1 4.10472 15.1163 9.79145 -1.9934 -0.675971 8.59173 +524 2 4.064 15.4281 8.88095 5.53492 -3.39313 -4.80569 +525 2 4.98866 14.7298 9.93327 -5.1567 4.83883 -4.62826 +526 1 7.25259 2.18349 14.6213 0.0617677 -13.2081 -4.74626 +527 2 7.15489 1.70536 13.7831 -3.1697 0.657011 7.79217 +528 2 7.60954 3.02479 14.3607 5.63067 15.2107 -2.58221 +529 1 18.5424 14.6505 2.1789 -18.2195 12.8357 -3.23587 +530 2 0.746704 15.0923 2.14855 14.3998 1.01071 2.70778 +531 2 17.888 15.3836 2.15154 2.4051 -14.4939 -0.146303 +532 1 9.96619 2.7451 12.9133 2.94451 10.1866 18.8487 +533 2 9.87163 2.03702 12.2777 -5.79326 -7.02869 -14.8001 +534 2 9.15272 3.27293 12.9211 3.46257 -1.15836 -6.04557 +535 1 2.89008 8.93457 13.069 -0.378913 -4.03455 -0.489948 +536 2 3.23396 9.82093 12.8894 1.3587 3.50504 -2.14294 +537 2 3.63423 8.44035 13.4383 1.00579 -2.11175 -2.13579 +538 1 3.23705 8.4538 3.70316 6.66602 15.0067 -51.1451 +539 2 3.68898 9.21355 3.2191 -13.1992 -22.9024 22.1933 +540 2 3.37321 8.55056 4.62635 6.35333 11.1623 30.2444 +541 1 5.63533 7.19464 8.56829 15.13 5.19196 -11.3333 +542 2 5.75579 6.23215 8.63413 -6.09463 5.83127 4.58457 +543 2 5.06463 7.50349 9.27803 -5.30623 -7.19668 4.50769 +544 1 14.8805 1.37043 1.98087 -12.9306 20.6627 -0.801435 +545 2 14.4834 2.20569 2.28334 5.69168 -11.9007 13.5915 +546 2 15.1168 1.59638 1.09054 15.1066 -6.121 -14.4277 +547 1 8.35206 15.1867 0.801551 -2.76223 -14.7585 -5.29804 +548 2 9.12264 14.9643 1.32951 11.031 8.33032 8.58299 +549 2 7.67017 14.6008 1.15941 -5.63761 -0.337967 -3.00039 +550 1 15.5896 1.3528 7.2086 5.32958 13.3681 13.2076 +551 2 15.0272 0.817571 6.66531 -11.4451 -13.4108 -9.89715 +552 2 14.9993 2.0562 7.52457 4.21653 3.3566 -1.64766 +553 1 5.02591 13.0452 18.4884 -9.20414 -3.59717 -21.6247 +554 2 5.46138 13.1397 0.681872 7.63488 2.92653 16.7381 +555 2 5.72796 13.1696 17.8326 -7.15584 3.38504 4.08457 +556 1 15.3795 8.51367 18.1423 -0.613664 -0.0581633 13.6311 +557 2 15.7206 8.99589 17.3938 3.47957 9.7554 -12.9134 +558 2 15.3333 9.18442 0.205917 -4.60531 -6.1888 -2.54679 +559 1 12.0939 3.05244 18.336 -15.98 21.6351 4.66001 +560 2 12.5019 2.66242 0.476891 0.147771 -8.75739 -8.71627 +561 2 12.3559 2.60872 17.5248 9.46456 -12.7769 5.34739 +562 1 13.1875 12.6757 5.16147 -9.52799 6.20775 -2.46737 +563 2 13.6969 11.8811 4.95337 3.5398 -1.69434 3.58065 +564 2 13.2525 12.8475 6.11376 6.90446 -8.64397 -1.04625 +565 1 6.03627 7.1613 0.0926319 -1.4976 11.1377 0.14104 +566 2 5.76921 8.10211 0.154014 9.70457 -9.32393 -3.08293 +567 2 5.20613 6.68485 0.159604 -1.55619 -3.41243 3.21991 +568 1 17.685 15.9184 14.9825 -1.37425 0.537856 -17.3926 +569 2 16.8502 16.3506 14.966 -20.4161 12.6054 20.7942 +570 2 17.7239 15.7506 14.0369 24.1644 -10.6132 -5.26117 +571 1 13.1805 0.948047 16.6125 -8.26177 1.73564 3.5107 +572 2 14.0455 0.715926 16.9626 7.25254 0.595142 -3.17693 +573 2 12.7267 0.0993777 16.5408 2.533 -1.4889 -4.3323 +574 1 11.0204 14.5878 7.33132 -13.7805 -25.7938 -0.586216 +575 2 10.2983 13.987 7.62969 9.87943 15.8321 -1.01987 +576 2 11.8217 14.058 7.45361 -0.254224 3.6388 3.5388 +577 1 17.5119 8.53957 2.08465 9.75653 -12.9638 -10.6953 +578 2 16.6633 8.36471 2.52368 3.0717 -2.74041 -4.8374 +579 2 17.6343 7.8268 1.40004 -7.84255 17.4574 20.9547 +580 1 12.3495 7.93856 1.97915 15.2682 -24.1922 3.95646 +581 2 11.8245 8.73298 1.97607 -8.33179 10.3297 -5.28986 +582 2 12.0289 7.32679 1.29658 -2.64171 9.95394 1.06163 +583 1 11.9622 14.6462 10.3592 5.19436 44.1652 25.6085 +584 2 12.1561 13.8266 9.98193 3.67183 -41.4058 -22.2867 +585 2 11.0169 14.8072 10.2884 -7.2612 -3.28322 -4.25289 +586 1 6.85285 6.99572 15.5659 -14.0155 -24.0568 -12.8099 +587 2 7.75988 6.91015 15.2685 9.48733 7.04308 1.07731 +588 2 6.80041 7.76332 16.11 4.63477 18.9896 15.1539 +589 1 8.01222 4.65145 13.4113 -36.8067 -34.3033 -31.6859 +590 2 7.3316 4.83402 12.7007 16.1602 -3.60309 24.697 +591 2 8.38377 5.47541 13.6286 15.6027 34.5994 6.21753 +592 1 13.4241 12.174 14.3057 -4.84328 6.02619 2.2323 +593 2 13.1628 11.2453 14.2138 0.984992 -0.986947 -4.38535 +594 2 13.8661 12.446 13.4834 -0.550032 -4.72607 1.54363 +595 1 14.7341 9.44221 7.2791 -5.07947 3.15833 13.2143 +596 2 15.5444 9.94699 7.52972 -16.5583 -4.09464 -2.76463 +597 2 13.9842 9.66778 7.87655 21.0159 1.38057 -11.435 +598 1 12.706 16.9897 3.14089 12.6698 -33.6085 3.29803 +599 2 12.7844 17.2146 4.05845 5.40916 5.57996 15.4808 +600 2 12.1668 17.6603 2.78193 -20.8699 29.0634 -19.4792 +601 1 1.09001 7.14262 17.4001 -13.5934 2.13623 7.48936 +602 2 0.156991 7.24832 17.6908 14.7769 -7.58529 -2.77652 +603 2 1.13731 7.55625 16.5284 -2.3111 1.37932 -0.487878 +604 1 12.8562 5.06495 15.6988 -8.68567 -0.702669 -5.76624 +605 2 13.5471 4.4122 15.5538 8.1837 -6.12965 4.55719 +606 2 13.3218 5.91347 15.6395 -0.893164 2.09785 3.54679 +607 1 2.45402 3.36746 5.11563 -15.0026 -7.91555 0.636238 +608 2 1.84292 3.24382 5.86687 4.72922 -2.7794 -8.95345 +609 2 2.91216 4.18226 5.3072 9.55717 10.9124 5.44962 +610 1 8.31869 11.1649 13.5414 -26.3953 31.2189 -67.0184 +611 2 8.3305 10.9362 14.4299 14.6498 -23.9054 54.2316 +612 2 8.96182 10.7076 12.9898 15.0794 -7.45176 14.931 +613 1 12.9219 1.43726 13.3082 8.40674 -27.4269 12.3988 +614 2 13.6356 1.33586 12.6838 7.08718 -5.3 -10.143 +615 2 12.6036 2.28403 13.0872 -17.61 33.9058 -2.44667 +616 1 6.45277 13.6094 2.15178 17.7292 -13.553 0.669437 +617 2 5.88225 13.9257 2.84987 -12.2826 9.62032 8.12495 +618 2 7.05696 13.0019 2.62135 -3.25561 7.9246 -7.28354 +619 1 15.9319 6.53462 12.7261 -1.3149 8.22476 -13.019 +620 2 16.4256 7.00237 12.02 -4.18033 -7.18445 13.3481 +621 2 16.3662 6.74364 13.5705 0.249391 -3.37031 -2.78146 +622 1 16.8119 0.703827 9.59317 0.0549178 13.2549 -11.7388 +623 2 16.9772 18.4048 9.65541 -4.88295 -11.6626 5.05601 +624 2 16.4803 0.847119 8.68154 -1.08178 -1.2883 7.79904 +625 1 6.11652 11.6489 8.33522 -7.45125 2.78057 4.10213 +626 2 5.22601 11.4682 8.68918 7.08294 1.77705 -0.544493 +627 2 6.44454 10.7788 8.07724 4.19277 0.895061 -4.04259 +628 1 2.82334 8.71064 0.367814 57.5944 7.33247 25.2144 +629 2 2.2601 8.16366 18.5098 -36.527 -13.587 -20.7071 +630 2 2.37171 9.41868 0.829256 -17.9324 0.137834 -3.43482 +631 1 10.1122 10.4601 6.54653 2.23323 -6.08635 8.59596 +632 2 10.5188 9.74717 7.06727 -1.60105 2.20328 -1.71973 +633 2 10.6949 10.5759 5.79445 1.91861 -2.10956 -11.6412 +634 1 6.75321 15.7504 6.59889 15.4627 0.902891 -8.22878 +635 2 7.26857 15.9454 7.3825 -2.17992 1.48032 8.28293 +636 2 7.22097 16.2558 5.90647 -13.1985 0.138133 2.05084 +637 1 6.44152 13.0383 5.65846 10.3967 8.14078 0.466175 +638 2 6.75357 13.9433 5.8413 -7.70657 -8.59676 1.70002 +639 2 6.06189 12.7174 6.48437 -0.213232 -3.44089 0.434225 +640 1 16.7867 12.5398 9.78373 -0.895423 12.3409 14.8939 +641 2 16.908 11.9251 9.05274 5.68732 0.178616 -8.50939 +642 2 17.2058 13.3939 9.58039 -4.06144 -12.2084 -5.14549 +643 1 6.11722 2.93773 2.78358 1.28645 13.216 -7.71479 +644 2 6.25944 3.86133 2.4934 3.99356 -9.45804 11.966 +645 2 5.80949 2.50246 1.9813 -4.27697 -8.38821 -0.209888 +646 1 10.8697 3.19981 3.26527 3.50346 -2.80617 2.55973 +647 2 10.3917 4.00785 3.47818 -6.11785 -2.03152 -1.59068 +648 2 10.4869 2.83625 2.45753 -2.48553 0.910808 2.03729 +ITEM: TIMESTEP +50 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.80494 6.94654 17.8995 24.4982 -1.06408 -3.00226 +2 2 7.9626 7.14317 18.2754 -25.5132 0.779993 7.28642 +3 2 8.754 6.09075 17.4755 -3.81212 -4.80634 -6.17786 +4 1 18.7076 8.28828 6.77862 -17.6183 19.7289 -45.7057 +5 2 0.378325 8.05756 5.8509 -9.14495 4.02657 32.4311 +6 2 0.533056 7.77742 7.41073 20.0311 -22.8668 16.2585 +7 1 8.47587 18.7144 6.8555 -15.9357 -0.720841 9.56566 +8 2 9.33674 0.260611 6.50709 17.8925 2.772 -5.71063 +9 2 7.894 0.699709 6.41588 1.40147 0.745568 -0.352682 +10 1 6.55032 1.74908 11.6806 -30.6389 -0.0206495 8.42613 +11 2 5.72229 2.20254 12.0188 30.9536 -14.8428 -8.23206 +12 2 6.26581 0.83583 11.4478 2.55871 18.5754 3.76962 +13 1 7.01034 5.66598 2.40366 42.8029 -38.9731 -13.6875 +14 2 6.35895 6.02285 2.96016 -30.9745 25.4116 27.1882 +15 2 6.9342 6.07183 1.55014 -9.7244 15.1829 -13.9093 +16 1 16.2046 10.2277 16.1038 24.2393 -12.7483 3.49627 +17 2 17.1446 10.5017 16.2161 -25.4373 -4.23616 -6.12234 +18 2 15.647 10.9645 16.3441 -0.0961828 13.5193 2.91036 +19 1 10.6483 14.9468 2.32679 16.6528 15.7411 4.7381 +20 2 10.6274 14.3584 3.09768 -0.623134 4.2367 -1.18236 +21 2 11.2712 15.6715 2.59359 -14.1521 -13.9994 -5.33424 +22 1 17.1661 8.23718 10.6306 -11.2967 1.73071 14.301 +23 2 16.7507 8.8212 11.3018 1.93853 -3.53361 -12.158 +24 2 17.9019 8.73965 10.2686 8.0864 2.26419 -0.719652 +25 1 14.7146 15.8737 16.457 -21.3602 13.4439 -13.9077 +26 2 13.7676 16.1527 16.3582 25.6738 -5.80999 2.03747 +27 2 14.7447 15.4629 17.3289 2.78446 -2.53877 0.107495 +28 1 12.1127 13.3961 0.516068 7.29043 -9.0569 -3.36162 +29 2 11.9491 13.4845 18.198 -4.88029 1.64951 11.237 +30 2 11.4672 13.8878 1.04861 1.29785 5.2885 -8.15688 +31 1 9.32313 5.46813 3.97213 7.80738 6.41636 -30.8752 +32 2 8.77956 5.22076 4.69796 -14.0602 -7.63701 27.6376 +33 2 8.66617 5.58024 3.26537 2.47672 -2.22308 0.129141 +34 1 1.75935 4.12111 11.6197 18.1342 -37.205 15.7411 +35 2 1.54791 5.00495 11.8916 -2.97584 25.4072 4.68628 +36 2 2.32145 3.72177 12.3424 -17.0092 10.631 -21.3466 +37 1 2.03979 6.80407 8.28533 9.98525 11.4794 16.6393 +38 2 2.53906 7.28349 8.98677 -9.97253 -7.08615 -13.1486 +39 2 1.84044 5.93856 8.67612 2.99865 2.8006 -7.53122 +40 1 5.41368 4.4431 7.98609 2.04847 -7.17668 -5.4397 +41 2 5.52021 3.53426 7.6768 1.69988 -8.04832 10.7211 +42 2 4.8597 4.83563 7.32005 -13.574 8.98698 -13.1921 +43 1 3.28639 2.94557 17.481 18.7711 -22.2673 -22.0629 +44 2 3.9564 3.24513 16.8336 -6.74837 -1.29983 9.82734 +45 2 3.01936 3.73284 17.9334 -14.3576 17.7403 14.3716 +46 1 7.43065 5.38409 6.1108 -4.02947 -12.3157 -7.88053 +47 2 8.04294 5.88377 6.62432 18.8075 23.5792 8.00277 +48 2 6.91671 4.96856 6.79731 -10.3369 -11.1081 4.55684 +49 1 9.79016 6.98523 11.9902 -10.4204 5.88316 -11.2143 +50 2 10.3735 6.44493 11.4296 -8.50476 3.87141 4.17676 +51 2 9.02941 7.28204 11.4255 18.3189 -8.29917 9.01359 +52 1 14.0741 3.64931 8.08693 10.5401 -0.215179 40.0548 +53 2 14.0167 4.44403 7.56769 -3.75439 10.9765 -10.3635 +54 2 14.3054 3.9684 9.00291 -5.13065 -9.75311 -28.2231 +55 1 4.53282 17.2396 3.96388 -3.36194 -12.9595 16.5635 +56 2 5.47422 17.3897 3.95236 14.0752 8.1678 -3.62607 +57 2 4.10275 17.6636 3.22639 -0.935466 5.38311 -16.6052 +58 1 16.4462 16.5922 10.2581 -38.5234 -1.88036 17.4962 +59 2 15.5721 16.6729 10.7424 33.2408 0.640367 -11.4138 +60 2 16.1948 16.0519 9.4989 1.36351 -0.703045 -4.07641 +61 1 1.99534 4.82647 0.326236 -5.72725 6.00108 -15.6714 +62 2 2.53752 5.17962 1.03714 5.87953 4.50688 4.90779 +63 2 1.76739 5.60304 -0.220726 -2.02535 -4.08014 4.56707 +64 1 11.5531 13.2812 16.3325 -4.55485 8.80091 5.86354 +65 2 11.0534 12.4701 16.4457 -6.69668 -7.45166 4.31247 +66 2 12.0841 13.1031 15.5561 8.82157 3.01133 -6.78989 +67 1 10.1577 11.0139 16.8858 -24.3839 23.6532 0.592397 +68 2 10.5791 10.1721 16.8528 10.3809 -28.4273 -2.47871 +69 2 9.20446 10.8554 16.7431 9.15295 -0.788439 1.53623 +70 1 11.769 17.4436 13.4724 -4.31264 31.1905 -3.85112 +71 2 12.3451 17.016 12.8258 4.51875 -1.42135 -0.782751 +72 2 11.9049 18.418 13.331 2.02313 -21.8103 4.25856 +73 1 6.43699 9.33747 12.2016 -14.3685 16.3251 29.571 +74 2 6.95929 8.94901 11.512 13.8657 -1.33735 -10.2504 +75 2 6.99936 9.91985 12.7612 -5.52999 -10.4188 -15.163 +76 1 16.2506 12.8362 2.68463 10.4823 17.07 -2.68352 +77 2 17.0784 13.3466 2.55935 -9.20242 -14.0812 1.4249 +78 2 15.565 13.5285 2.65461 0.126865 -8.38924 5.57615 +79 1 0.688432 12.6159 5.91845 40.3739 4.73102 13.6953 +80 2 0.965548 12.5027 5.00914 1.60296 -4.44104 -10.7732 +81 2 18.4099 12.7183 5.90627 -44.0147 0.977299 -7.7541 +82 1 5.23962 16.4285 18.4285 2.37714 -1.84876 8.0205 +83 2 5.78786 15.7427 18.0572 3.65919 -12.8888 -12.968 +84 2 5.57695 16.4825 0.678793 -3.22986 7.92557 6.36641 +85 1 0.598604 7.70507 4.14138 -20.7786 -13.2635 7.16681 +86 2 18.6305 8.09263 3.50172 -0.345103 1.12768 -4.13337 +87 2 1.46117 7.8354 3.77399 24.2365 9.84596 -7.22116 +88 1 3.12664 8.94501 6.49467 58.7355 2.96877 -21.5552 +89 2 3.79065 8.46432 7.02112 -12.6266 6.35685 -1.15291 +90 2 2.29097 8.86083 6.88074 -41.9399 -6.12221 23.1652 +91 1 7.26988 10.3368 16.2836 11.5372 -0.463039 -18.2668 +92 2 6.61986 10.5879 15.6307 -2.48374 3.02842 -3.04887 +93 2 6.78814 10.3049 17.1036 -3.00573 -3.18181 16.2709 +94 1 11.123 0.978368 5.0094 -10.4546 8.12706 3.20432 +95 2 11.0717 1.86722 4.62246 7.34447 -2.45893 1.30193 +96 2 10.765 0.419141 4.31729 -2.84542 -7.68945 -6.73121 +97 1 4.36745 2.7997 13.2283 -2.96005 27.1446 -27.16 +98 2 4.67681 3.13482 14.0684 -0.492375 -1.19152 9.60175 +99 2 4.17697 1.87548 13.305 -2.22526 -24.419 13.8486 +100 1 8.37947 10.1962 1.80259 -4.93469 16.4683 -10.3397 +101 2 8.22749 10.8872 2.46356 1.16914 -1.49574 -1.6966 +102 2 8.71062 9.47199 2.30942 8.47484 -21.3721 12.0127 +103 1 10.3811 1.71408 15.5377 20.686 0.359172 -10.6925 +104 2 11.354 1.66546 15.4316 -15.8773 -5.06945 10.6173 +105 2 10.0964 2.02238 14.6685 -5.35844 0.742925 -2.36882 +106 1 2.68357 12.8347 7.81396 4.59418 8.51704 7.17464 +107 2 3.18489 13.5948 7.4697 -3.72618 -6.19027 -0.541735 +108 2 1.90686 12.7457 7.24856 2.42229 -2.05385 -5.50174 +109 1 3.74169 11.6981 5.12659 20.4064 16.2552 5.07347 +110 2 3.6031 10.8525 5.51837 -2.34348 -17.0347 14.1119 +111 2 3.05756 11.7956 4.48632 -17.1397 4.43934 -14.0111 +112 1 6.78306 14.4202 16.945 8.30127 18.455 -2.7408 +113 2 7.70256 14.7228 17.0235 -7.00262 -4.27134 -0.857039 +114 2 6.4289 14.8468 16.1479 2.30915 -9.19793 -2.69046 +115 1 14.2185 14.5268 3.31588 -23.2154 9.18115 10.9982 +116 2 13.6682 15.2954 3.06852 12.5657 -5.26706 1.63848 +117 2 13.7604 14.1667 4.10581 9.83524 -2.33371 -14.8176 +118 1 8.44676 18.1227 16.0393 7.73472 16.3177 -1.68025 +119 2 9.01165 17.3799 16.1525 3.2644 -34.6246 10.2309 +120 2 9.11477 0.14931 15.8801 -4.9724 20.6673 -2.43491 +121 1 4.70679 1.64341 4.91058 -17.3364 -32.3489 41.2122 +122 2 3.86106 2.04855 5.10849 -6.14561 5.35271 -2.51022 +123 2 5.03045 2.1011 4.1778 23.045 28.1017 -39.82 +124 1 14.9769 12.6712 16.4491 28.5182 -25.5733 -37.1858 +125 2 14.5585 13.1664 17.1249 -24.0861 16.0366 17.7329 +126 2 14.4092 12.4828 15.6576 3.30334 14.0855 25.2157 +127 1 15.7195 18.4537 16.8862 -41.4911 -4.79998 -47.5194 +128 2 16.474 18.4695 17.416 41.6971 -5.3201 37.0536 +129 2 15.5173 17.5216 16.6763 -0.165283 4.31671 10.9236 +130 1 1.26675 1.20722 16.5821 1.91531 -3.73727 -7.96899 +131 2 2.06576 1.68562 16.7995 9.77153 8.32265 -0.296149 +132 2 0.695796 1.45596 17.2985 -12.9769 2.74169 12.7471 +133 1 18.1595 4.46894 15.9392 -8.68238 9.49864 15.6389 +134 2 18.21 4.01948 15.1094 2.12602 -9.4702 -15.5502 +135 2 0.321646 4.30297 16.4236 6.52219 -0.344151 0.382064 +136 1 12.2433 16.9631 16.1365 30.1535 25.9085 -42.0202 +137 2 11.4764 16.7912 16.6244 -43.4812 -17.6238 21.6018 +138 2 11.9609 17.1491 15.2014 5.35486 -10.4534 20.1012 +139 1 16.0404 2.55502 18.1172 12.6912 -10.4842 9.42679 +140 2 15.6589 3.39683 18.3503 -6.59057 14.1496 4.33812 +141 2 15.9441 2.46009 17.1755 -7.16214 2.08136 -15.1428 +142 1 6.70635 13.8458 10.192 -16.5385 -19.5662 -16.6234 +143 2 6.46743 13.4829 11.0519 3.62966 4.37567 6.36784 +144 2 6.41781 13.1513 9.56037 11.5929 10.5707 5.5488 +145 1 10.1419 18.3987 2.73425 -19.4638 -25.4286 12.0097 +146 2 10.2073 0.494584 2.15475 6.00155 18.7458 -18.7245 +147 2 9.2799 18.0069 2.48337 13.6051 6.39322 6.25061 +148 1 3.04438 17.7185 6.11283 5.61436 7.93422 -10.0091 +149 2 2.18521 17.5434 5.71014 -2.22655 1.93918 -4.29169 +150 2 3.60431 18.0006 5.35738 -6.06642 -9.44159 14.8188 +151 1 12.59 16.8727 7.99688 3.41749 0.26688 0.968442 +152 2 11.9163 16.1959 7.96054 -9.29683 -10.0995 -8.1817 +153 2 12.3648 17.371 8.78825 5.01363 9.11979 0.25951 +154 1 14.8925 15.2941 8.21002 11.8118 0.190541 -21.4145 +155 2 14.0466 15.7377 8.15471 -7.99071 7.70949 7.81769 +156 2 15.2804 15.4945 7.32486 -0.0803457 -7.85257 22.8773 +157 1 17.7158 18.2428 0.330134 42.1686 22.2301 9.80157 +158 2 18.5718 17.7519 0.320787 -20.6577 0.0591745 -9.59458 +159 2 18.0296 0.514827 0.540707 -19.3386 -19.3229 -5.27308 +160 1 0.848087 10.4587 1.36302 27.1846 51.9138 -28.6855 +161 2 0.125428 9.973 1.66463 -44.0007 -34.6793 17.9508 +162 2 0.450253 11.2027 0.827225 17.544 -22.8417 14.6566 +163 1 1.73752 12.2317 3.35921 -10.6222 -3.23772 -40.3174 +164 2 1.50468 11.5771 2.65039 3.80547 3.73659 24.0112 +165 2 1.78112 13.0447 2.82871 4.93945 -0.670418 11.0651 +166 1 0.61763 17.2312 4.89977 -31.3278 9.09129 49.7394 +167 2 18.753 18.067 4.93438 12.2337 -8.61092 -13.4292 +168 2 0.309388 16.8063 5.75223 19.8395 0.744545 -34.548 +169 1 1.12081 0.925337 9.40389 -12.5044 -10.6635 0.652446 +170 2 1.34187 0.581545 10.2981 -6.32089 4.74016 -12.6461 +171 2 0.253358 0.524348 9.17819 18.5788 9.22491 5.8567 +172 1 16.7331 2.36195 13.2995 -4.07693 -18.6231 24.2357 +173 2 16.9587 2.56306 12.4093 5.05193 8.99127 -27.3142 +174 2 16.5121 1.41005 13.3069 2.86591 9.33714 2.00751 +175 1 2.6752 15.8404 12.084 -17.9655 13.8891 -13.7444 +176 2 3.1007 15.4046 12.7977 10.8605 -10.5552 20.9848 +177 2 3.18035 15.6022 11.2985 0.61387 1.79975 -2.62876 +178 1 16.4324 15.6688 6.07894 -11.0906 -29.1832 8.11987 +179 2 17.3135 15.6699 6.4691 2.82688 3.86386 -3.5648 +180 2 16.3493 16.3586 5.42897 4.86465 16.2346 -9.8305 +181 1 5.78229 5.11191 11.8099 -13.8406 10.2937 3.29755 +182 2 5.26053 5.84491 12.2174 12.8802 -11.8636 -2.84442 +183 2 5.17337 4.36282 11.7377 2.58239 3.92087 3.15374 +184 1 15.1463 4.86734 0.794152 0.864651 12.4924 -33.9562 +185 2 14.9842 4.50309 1.65022 -3.17819 -5.74322 26.2661 +186 2 14.3662 5.39647 0.571272 5.91156 -4.56503 2.45287 +187 1 16.3343 16.3902 2.05204 -8.53913 3.9795 31.3204 +188 2 16.0972 16.7844 2.93864 3.99019 -13.2916 -26.145 +189 2 16.6713 17.1379 1.5654 4.18336 9.27065 -12.2854 +190 1 0.251768 4.84384 3.8243 -5.07672 -49.1083 -0.618349 +191 2 0.303365 5.75864 3.98841 7.12191 44.1717 7.46524 +192 2 0.849427 4.39339 4.43966 -1.76195 8.48948 -7.42491 +193 1 2.97026 15.0637 15.1648 0.961584 14.1925 -19.6325 +194 2 2.86359 14.8338 16.0871 -5.01806 -10.0022 10.5852 +195 2 2.57214 15.9549 15.1104 2.70735 -9.48442 0.706884 +196 1 1.14871 14.6442 9.53518 -42.8529 -19.211 3.24989 +197 2 2.06628 14.849 9.52706 28.3433 -3.949 4.37311 +198 2 1.01023 13.7361 9.90627 12.772 19.4662 -8.86837 +199 1 13.5229 16.5669 11.532 20.3549 -23.4698 16.7524 +200 2 13.3606 17.2446 10.8944 -12.6142 15.9017 -14.8664 +201 2 13.2357 15.729 11.1267 -5.06335 10.0173 1.96475 +202 1 4.64907 1.44855 0.782556 14.1843 16.2277 -15.4645 +203 2 4.13811 2.00007 0.175187 -1.198 1.13782 0.731863 +204 2 4.05002 0.760268 1.05534 -6.36237 -9.04178 10.9284 +205 1 1.45269 18.5669 11.8512 9.08594 -18.5638 20.5671 +206 2 1.3209 0.513151 12.6112 1.192 -1.45307 -0.682323 +207 2 1.82538 17.7349 12.2384 -6.22294 17.2853 -13.4176 +208 1 11.5083 10.14 3.99231 -12.3356 -6.67004 24.2683 +209 2 11.3008 10.4626 3.12291 -1.30093 6.41155 -12.7666 +210 2 12.4624 10.1697 4.04844 12.7044 -2.53047 3.95194 +211 1 8.22637 12.1595 3.70182 22.1984 -6.43536 -24.1249 +212 2 9.06359 12.543 3.994 2.39995 3.52197 1.898 +213 2 7.64229 12.2644 4.4292 -22.7553 4.87752 31.4773 +214 1 14.5041 4.04055 3.28708 -18.3332 1.47774 -0.327682 +215 2 14.9873 3.94029 4.11097 10.9182 2.80533 4.02706 +216 2 13.7169 4.55783 3.53097 2.05743 -3.46177 -0.871318 +217 1 5.62743 1.64825 7.52429 33.006 28.3977 -54.9531 +218 2 5.01294 1.12929 7.98513 -35.2623 -28.0367 23.7041 +219 2 5.43705 1.49837 6.5464 4.70081 6.15592 32.4881 +220 1 17.8649 1.10253 4.84999 -3.85271 -3.04411 9.89583 +221 2 18.5316 1.48406 4.28754 10.0589 0.579138 -13.4652 +222 2 17.9089 1.63153 5.65146 -2.44801 0.268727 5.2117 +223 1 6.82865 9.41118 4.50161 13.9732 -1.80028 18.7676 +224 2 6.94383 9.68391 5.43824 -8.65407 -5.40133 -16.2957 +225 2 7.70845 9.07477 4.25578 -5.27921 1.965 -0.840285 +226 1 2.66065 14.8943 1.98186 -2.57221 -9.24308 25.7982 +227 2 3.31586 14.7955 2.69868 -8.68087 -2.61777 -7.29774 +228 2 3.12007 15.367 1.30687 7.03004 7.53846 -18.6884 +229 1 17.3318 12.9277 13.2024 14.566 -8.41998 -6.98679 +230 2 16.4646 13.2932 13.3909 -3.11164 10.4066 0.365823 +231 2 17.9245 13.6681 12.9725 -15.6789 -3.68206 1.74475 +232 1 14.9332 10.5631 1.42248 26.9386 23.5346 15.1493 +233 2 15.5074 11.3103 1.7869 -22.4798 -24.8917 -12.2482 +234 2 14.0193 10.8096 1.5708 -2.19259 1.9486 -0.294463 +235 1 5.71089 6.73608 4.5629 -4.22281 28.118 -3.03355 +236 2 5.94827 7.69445 4.64343 -4.82413 -18.183 -7.3163 +237 2 6.31292 6.28304 5.16113 4.14578 -2.25186 0.1588 +238 1 7.97883 8.3192 10.3001 7.8407 -5.86676 -34.7961 +239 2 8.53275 9.01778 9.91692 4.61581 1.53144 9.76809 +240 2 7.67805 7.86001 9.48783 -4.88471 -0.599295 18.8237 +241 1 13.4226 18.4487 5.72909 4.08913 1.21656 -6.98532 +242 2 12.585 0.250804 5.52036 7.76092 4.80861 -0.84516 +243 2 13.2097 17.9386 6.50687 -2.642 -10.6174 11.5339 +244 1 0.0869602 2.62265 0.223952 -9.8031 -15.3274 -6.51765 +245 2 17.9117 2.88521 18.4333 -9.97249 -6.92357 5.22107 +246 2 0.604672 3.41479 0.198655 20.2406 16.0872 6.75582 +247 1 12.7806 11.0275 9.75202 47.836 -29.2198 23.6504 +248 2 11.892 10.9606 9.4924 -44.5823 -3.62186 -10.7645 +249 2 12.9839 10.1194 10.1272 -4.83434 23.2951 -13.1663 +250 1 0.705171 12.1501 11.0469 -11.5221 2.5881 -10.739 +251 2 18.3743 12.1368 11.1638 13.8029 4.27958 5.25964 +252 2 1.13401 12.4861 11.8379 -3.00537 2.27024 12.2218 +253 1 5.1174 7.31342 13.4172 11.1181 3.69095 0.765545 +254 2 5.61979 7.99643 12.9358 -2.94992 -2.73128 4.30069 +255 2 5.6521 7.15272 14.218 -5.77355 -1.15348 -7.33249 +256 1 1.197 6.86571 11.8595 38.3077 26.916 14.5555 +257 2 0.451078 7.27927 11.4324 -8.7071 4.85333 -5.01967 +258 2 1.83731 7.62187 12.0983 -31.0022 -32.2106 -6.42275 +259 1 15.4885 9.63727 12.3206 16.478 -29.8614 -10.1392 +260 2 15.1661 10.5006 12.1398 -12.0715 29.4427 -0.903292 +261 2 15.2587 9.41843 13.2151 -2.74274 1.51694 14.7591 +262 1 16.5678 12.6919 5.49509 2.68502 5.28083 21.2685 +263 2 16.324 13.6184 5.59953 -0.326156 6.48336 2.9395 +264 2 16.4016 12.5196 4.57887 -2.84479 -5.20052 -25.0662 +265 1 6.28213 9.87258 0.0490999 16.8985 1.83912 15.6964 +266 2 5.56262 10.3905 0.421328 -3.89363 2.12479 6.12138 +267 2 7.01982 9.90555 0.722608 -19.7924 2.8001 -17.1777 +268 1 12.2865 6.1036 4.06304 19.2748 24.5544 -29.5048 +269 2 12.3306 6.8161 3.36437 1.4085 -17.3408 22.8012 +270 2 11.3814 5.83426 4.0192 -21.2841 -11.2083 4.33393 +271 1 0.298047 12.7955 0.166375 -3.43648 3.64279 0.0778505 +272 2 -0.0290314 13.4316 0.817326 3.1389 2.62115 2.93426 +273 2 18.4391 12.9788 18.0124 -4.25126 3.67416 -7.60949 +274 1 3.647 18.6117 8.59889 -15.5834 11.8668 6.1299 +275 2 3.50703 18.267 7.70639 0.18727 -3.89186 2.0216 +276 2 2.76186 0.338497 8.83167 17.7751 -6.65964 -2.12733 +277 1 7.50606 17.376 4.49824 -10.0508 -46.4512 11.7168 +278 2 7.49016 18.3059 4.51667 7.03352 43.591 -0.815572 +279 2 7.72157 17.1186 3.60818 -1.05523 3.68228 -12.2984 +280 1 9.25162 17.1195 12.2401 -20.7119 -1.17481 -13.1138 +281 2 9.34873 16.3083 11.723 0.965197 -1.09758 -0.258815 +282 2 10.0653 17.2534 12.7074 19.1017 -2.42392 11.5163 +283 1 13.35 12.9891 7.98546 26.3101 20.7404 -8.62941 +284 2 13.4089 12.1901 8.49273 -4.66259 -15.0904 10.7497 +285 2 14.2093 13.4501 8.17144 -24.2961 -0.252284 -5.87391 +286 1 14.9018 2.99422 15.3537 -18.6075 -8.06583 14.6174 +287 2 14.2375 2.30647 15.2045 2.81445 1.4476 3.5012 +288 2 15.4631 2.94521 14.5905 14.0528 3.89371 -13.7736 +289 1 9.86333 15.5824 16.9775 -1.70109 -0.0675876 9.27141 +290 2 10.3396 14.7637 16.7526 0.856458 3.65656 -1.57854 +291 2 9.55317 15.4797 17.8978 1.12056 -0.962034 -11.839 +292 1 11.2957 8.40029 16.577 -16.0633 -20.1101 7.86553 +293 2 10.6817 7.8482 16.0424 7.68237 12.4971 4.88138 +294 2 11.3251 7.92133 17.4322 4.78934 8.39937 -13.6138 +295 1 3.89281 18.1695 16.7848 -3.14598 -18.8551 -14.8366 +296 2 4.41813 17.5168 17.2844 -2.97968 13.5676 2.86087 +297 2 3.87713 0.360621 17.2331 6.32956 9.89438 13.0847 +298 1 2.18947 4.17934 8.91366 -18.0693 4.35017 -17.8699 +299 2 3.09766 4.08917 8.6846 23.1764 -2.78898 -7.58361 +300 2 2.16493 4.06394 9.84833 -5.05649 -4.17918 28.8808 +301 1 9.87375 10.372 9.69798 10.3489 -25.1121 17.1783 +302 2 9.47622 11.1704 9.40878 -10.9495 28.2307 -13.2887 +303 2 10.0218 10.4724 10.6474 2.61027 -3.39635 1.23761 +304 1 9.66501 0.904023 10.8717 -13.0386 -22.5074 -9.87351 +305 2 9.3051 0.0213231 11.0865 8.01248 8.88818 8.11202 +306 2 9.06191 1.19139 10.169 9.00305 9.82525 0.172013 +307 1 9.18563 15.0903 10.2115 17.1556 13.6164 1.72702 +308 2 8.73275 15.8289 9.78742 -0.477718 6.62954 -2.89772 +309 2 8.53792 14.3995 10.1946 -15.8858 -12.7719 2.13472 +310 1 0.946133 9.58267 10.2797 -17.999 7.07835 7.04569 +311 2 0.977457 10.4775 10.6382 -6.96742 -0.068666 -4.76802 +312 2 1.85682 9.38261 10.1843 21.4216 -13.3352 -8.00245 +313 1 16.9414 4.83421 8.13223 15.4014 12.0295 -27.8426 +314 2 16.4342 5.57084 8.44793 -11.0978 12.5109 2.31217 +315 2 16.8158 4.17203 8.77314 -2.49922 -25.6846 24.7871 +316 1 14.7535 14.7061 0.203986 15.073 4.98951 -2.11802 +317 2 15.1043 15.2916 0.890887 3.3452 -1.27018 2.88153 +318 2 13.9621 14.3164 0.552408 -18.4772 -7.94901 9.40987 +319 1 3.67958 11.0243 9.53991 2.98139 -0.929731 17.0732 +320 2 3.55398 11.294 10.4695 5.20942 3.18167 -4.3207 +321 2 3.23108 11.6955 9.00414 -3.72853 0.365488 -5.84942 +322 1 11.2021 10.759 1.44219 -17.3262 -13.0718 -7.65614 +323 2 11.58 11.5828 1.16251 10.55 19.7497 -9.01804 +324 2 10.309 10.7579 1.05212 6.07305 -2.69648 6.21388 +325 1 13.1662 7.17502 12.7531 25.9391 -3.29657 1.887 +326 2 14.1362 6.96154 12.7671 -19.0435 5.16748 0.470499 +327 2 12.7272 6.32599 12.8606 -4.03684 -6.30893 0.442018 +328 1 9.61497 1.86018 0.978015 -9.58691 9.0933 -29.7593 +329 2 8.82052 1.59363 0.443821 14.7013 3.9795 16.3864 +330 2 10.1598 2.41617 0.376969 -4.12787 -12.2318 8.97473 +331 1 10.6544 13.5231 4.58863 -13.6132 -6.73185 -2.44549 +332 2 11.4017 12.9559 4.77554 12.969 -5.04099 -4.5155 +333 2 10.624 14.0848 5.36102 -2.93668 8.13722 11.8558 +334 1 14.451 1.77042 10.9566 -5.06993 -21.3108 1.92478 +335 2 15.2282 1.34301 10.5576 -2.05514 6.77792 0.416034 +336 2 14.5487 2.7176 10.8324 3.84606 4.21375 0.609558 +337 1 14.5616 12.2019 11.6619 17.6804 1.81894 22.1071 +338 2 15.3038 12.427 11.1092 19.6924 5.46932 -2.69443 +339 2 13.8862 12.1117 11.0284 -35.3643 -9.54852 -21.0379 +340 1 8.20666 5.07147 9.84086 19.0973 -30.0877 -21.2342 +341 2 7.45963 5.1784 10.3955 -25.2729 10.7477 18.5337 +342 2 8.15765 4.10536 9.6198 7.47394 24.0469 -0.436218 +343 1 1.5637 16.9015 18.3956 -12.4387 -25.8837 12.5929 +344 2 2.10927 17.2609 17.7108 10.7809 10.3745 -20.1818 +345 2 1.47705 15.9462 18.1578 7.28008 19.3441 8.23831 +346 1 1.51254 17.2865 15.33 -55.1424 19.1245 13.5119 +347 2 1.44158 18.2256 15.6397 11.4216 -23.3977 -5.64032 +348 2 0.55797 16.9673 15.4072 37.0312 4.44622 -8.61518 +349 1 3.63692 5.75726 6.07961 7.7365 -18.3794 -8.43759 +350 2 3.1745 6.31944 6.69962 -9.61621 11.1355 4.40451 +351 2 4.08899 6.28836 5.40075 -0.121738 1.87808 9.22135 +352 1 12.4625 9.47055 14.2033 -9.88788 31.7301 7.89028 +353 2 12.9131 8.72585 13.8435 10.9703 -26.4307 -11.7769 +354 2 12.2412 9.2145 15.1039 -0.841012 -4.82452 5.58465 +355 1 4.05279 15.2823 6.91192 -35.0907 -10.5097 14.3913 +356 2 3.49702 16.0377 6.67476 5.8423 0.670453 -1.17602 +357 2 4.92638 15.5321 6.67665 32.7349 8.37925 -5.72993 +358 1 0.666426 8.62945 15.01 -4.81633 6.31993 2.8284 +359 2 0.390025 9.55783 15.0778 2.6081 -0.187855 1.05312 +360 2 1.36445 8.64555 14.3512 6.1817 -1.74341 -6.99991 +361 1 12.9834 8.27358 10.2916 -19.5051 6.59204 10.6567 +362 2 13.6375 7.73399 9.85191 12.7638 -5.94229 -3.5145 +363 2 12.8815 7.86968 11.1799 4.96282 8.38227 -11.7258 +364 1 15.3269 7.75333 3.56288 29.5219 38.2257 -22.8776 +365 2 14.5855 7.35684 3.13467 -21.9298 -17.371 4.59449 +366 2 15.5403 7.50003 4.45743 -10.8574 -16.6026 13.017 +367 1 17.2887 6.69393 0.021468 15.5778 -19.6292 8.74644 +368 2 16.7574 5.92192 0.248673 1.14134 -1.83764 1.32773 +369 2 16.6558 7.32534 18.3698 -22.9594 20.3863 -6.57681 +370 1 8.86981 6.94597 7.81474 24.2415 27.8548 -9.55577 +371 2 9.77577 7.36617 7.90295 -24.2622 -15.8521 -2.69303 +372 2 8.7837 6.29392 8.50186 -0.35036 -13.7271 19.3897 +373 1 12.3819 0.576227 1.23609 4.50683 -3.19553 -2.96149 +374 2 13.3476 0.534404 1.26268 -2.04299 5.45052 6.49319 +375 2 12.129 0.50298 0.316799 -1.00379 -2.5807 -2.54403 +376 1 5.62478 15.1294 14.5559 -8.95515 -20.8805 6.21096 +377 2 4.66749 15.251 14.733 11.0075 0.339747 -2.61971 +378 2 5.99586 15.9305 14.1948 2.79164 18.0184 -3.26028 +379 1 3.86891 6.41255 1.75203 -0.0773217 -5.81596 13.5476 +380 2 3.55695 7.28194 1.50076 -6.60469 12.2107 -8.14743 +381 2 4.09127 6.52195 2.68979 -0.816275 -1.80663 -6.76426 +382 1 3.9342 11.5843 12.3776 -18.6931 -4.72392 -0.912594 +383 2 4.79227 12.0122 12.4616 2.30575 0.246561 2.78418 +384 2 3.29871 12.1178 12.8946 9.72132 -5.51488 -9.32366 +385 1 5.32882 3.8676 15.8786 0.594801 -80.2026 -15.123 +386 2 6.00417 3.18473 15.5574 -21.0433 25.388 14.8589 +387 2 5.72544 4.69544 15.8213 26.1638 51.9163 -2.72297 +388 1 14.3304 10.2034 4.48175 -27.4096 24.8129 53.7077 +389 2 14.5884 9.79586 5.33863 -8.33179 4.59428 -12.4543 +390 2 14.8538 9.80174 3.84099 29.6706 -27.6476 -38.9945 +391 1 7.77951 17.4021 9.16969 8.83259 -7.31352 -4.45478 +392 2 6.90706 17.6601 9.4324 -15.0276 -0.0996042 12.8709 +393 2 7.95009 17.9588 8.40488 9.49987 1.3194 -6.72214 +394 1 4.51552 14.5162 3.99356 4.98181 -4.90212 -22.3913 +395 2 4.52626 15.4247 4.27156 -0.518589 17.7617 2.00307 +396 2 4.31207 14.0204 4.77138 -3.57212 -17.3619 18.7252 +397 1 14.1875 7.4375 15.7998 -22.901 -10.8896 -16.0938 +398 2 15.1146 7.35808 15.6286 24.9688 -1.25651 -4.60954 +399 2 14.1131 7.89225 16.6248 1.32628 8.65776 19.0596 +400 1 2.98527 18.3068 1.9119 -4.72699 -30.9822 -37.1172 +401 2 2.49826 17.7826 1.20191 12.7581 13.6458 27.4428 +402 2 2.34371 0.225349 2.32895 -15.9948 14.8465 9.72817 +403 1 8.01181 1.59883 4.56348 -29.7821 5.07108 -10.5683 +404 2 7.46781 2.03632 3.88017 -2.37558 -3.45248 10.775 +405 2 8.87859 1.65459 4.20584 24.9106 -1.40589 -4.13938 +406 1 2.43696 14.1424 17.6778 32.6678 8.55365 0.150748 +407 2 1.74447 13.6484 18.0869 -17.757 -15.5673 8.49591 +408 2 3.25626 13.7213 18.0204 -5.64692 6.54589 -2.94203 +409 1 0.856601 1.76819 13.8909 -34.0133 7.6587 12.0684 +410 2 0.79549 1.64555 14.8654 10.1884 -1.39389 -18.6264 +411 2 18.5699 1.97567 13.6249 24.5068 -3.80874 6.24474 +412 1 4.3972 0.0813689 13.9033 -13.8751 0.78744 16.7708 +413 2 5.2251 18.2898 13.7459 20.8939 -4.75733 -3.28132 +414 2 4.21678 18.5292 14.8441 -3.95615 2.50922 -10.6456 +415 1 7.163 0.723926 18.3524 28.8431 -20.8152 -22.3389 +416 2 7.29578 0.265373 17.4701 -6.89821 16.5948 25.8874 +417 2 6.28988 1.09447 18.4079 -18.4483 2.86302 0.00697782 +418 1 16.0461 18.4126 13.9592 23.9709 4.87143 24.0859 +419 2 15.127 18.3862 13.8391 -39.1169 -4.38354 -15.9017 +420 2 16.1011 18.5404 14.9193 8.5862 0.360016 -3.75437 +421 1 10.1416 4.5234 16.2814 33.6533 37.5162 -8.59515 +422 2 11.1148 4.69187 16.0483 -33.0569 -13.9639 15.4314 +423 2 9.96481 3.59397 16.253 2.9151 -23.0089 -4.34536 +424 1 15.9284 17.7644 4.42623 32.451 -11.9188 -9.4973 +425 2 16.5348 -0.134683 4.55752 -3.00893 1.73986 -2.0661 +426 2 15.0985 18.0471 4.75447 -36.3204 13.6328 11.8833 +427 1 7.01478 17.4412 13.8546 -37.2955 -8.85564 -21.6385 +428 2 7.52749 17.7553 14.5758 15.4879 9.12118 24.9138 +429 2 7.64547 17.2338 13.1683 11.7367 1.38126 -7.54157 +430 1 13.2517 6.48941 6.59541 21.6379 18.6409 -4.45059 +431 2 14.0732 7.02646 6.4901 -17.572 -15.5204 8.29538 +432 2 12.9904 6.33391 5.6816 -8.39128 -3.46546 0.217322 +433 1 7.82903 2.34082 9.30706 0.848413 1.46751 38.8479 +434 2 7.32489 2.17899 10.1397 9.78087 5.93227 -12.3925 +435 2 7.21411 2.12937 8.62642 -15.7826 -8.09866 -24.9258 +436 1 15.1931 14.7992 13.6996 5.60594 -14.9485 0.236255 +437 2 14.8724 15.0774 14.5533 -1.16755 2.2837 13.7936 +438 2 15.0044 15.5062 13.0994 -6.5851 10.7381 -11.5383 +439 1 9.39722 8.31385 3.80437 -4.07127 17.2834 -4.44624 +440 2 10.2713 8.68973 4.00761 -3.0526 -2.08627 -0.470344 +441 2 9.46128 7.36215 3.86627 5.27028 -8.92187 3.93672 +442 1 17.7859 13.5845 16.3834 -19.0466 -29.0207 18.2461 +443 2 16.8295 13.3731 16.3512 7.31415 3.8698 0.00611806 +444 2 17.8697 14.4051 15.917 1.12921 18.7325 -11.1152 +445 1 4.94376 10.5922 2.82245 -18.0715 22.8685 -14.9529 +446 2 5.66076 10.3167 3.37377 16.0421 -11.7082 13.1735 +447 2 4.72943 11.4907 3.12728 0.871258 -13.2337 -1.99455 +448 1 3.75648 8.36099 10.0882 -2.83158 17.8244 -9.78689 +449 2 3.88314 9.30809 9.8443 -3.15161 -16.2727 -0.870444 +450 2 3.74879 8.36585 11.0419 0.849549 -1.60464 13.0402 +451 1 15.9818 6.99244 6.07768 -13.3688 18.7296 1.03973 +452 2 16.7792 7.41732 6.38792 13.9106 3.61693 3.9934 +453 2 16.2026 6.08994 5.88298 6.53831 -20.9898 -2.75314 +454 1 15.1161 7.11481 9.04764 0.565665 -31.7989 38.5144 +455 2 15.8028 7.45918 9.62834 5.57768 4.61323 -0.34974 +456 2 15.1416 7.62578 8.27782 1.5606 28.4329 -39.6698 +457 1 6.26636 12.9592 12.746 15.2088 -10.2167 -2.30532 +458 2 7.09456 12.5046 12.9751 -5.12301 -5.10662 -0.512627 +459 2 6.13107 13.5604 13.4742 -6.25916 17.1748 9.55337 +460 1 12.1295 4.51914 13.098 -40.0586 -31.7334 -0.542355 +461 2 12.3128 4.55827 14.0372 7.66008 7.87672 6.17129 +462 2 11.3118 3.91999 13.0515 32.2373 26.2449 -7.62055 +463 1 11.3854 8.14886 7.92202 -18.4022 6.94815 -10.6415 +464 2 11.9487 7.53516 7.44565 12.5498 -6.92106 -4.31871 +465 2 11.7891 8.26504 8.77918 7.07043 -0.608458 13.7447 +466 1 17.1486 10.8722 7.52372 -29.3422 15.2924 19.4167 +467 2 17.741 10.1746 7.28593 21.144 -15.6164 -13.9006 +468 2 16.9754 11.4691 6.78151 4.60435 -5.53137 -7.06809 +469 1 5.26553 18.1239 10.9774 20.3802 -2.13667 -3.01104 +470 2 4.75345 17.8709 11.7323 -12.4512 -5.88679 12.7575 +471 2 4.64325 18.2391 10.2688 -13.5246 2.23536 -17.92 +472 1 7.60715 17.4884 1.7834 -2.49749 -8.82149 -34.1915 +473 2 7.92668 16.7242 1.2322 -11.5566 19.54 16.0619 +474 2 7.18999 18.106 1.13139 15.7932 -7.79309 14.6318 +475 1 1.92845 12.8983 13.5911 -4.1829 -6.61346 -8.43532 +476 2 1.49445 12.3761 14.2737 -4.42561 -3.96966 1.7572 +477 2 2.30088 13.6477 14.0465 3.83448 15.9215 12.3791 +478 1 9.57624 6.80131 14.8487 2.82943 -31.3701 -0.177857 +479 2 9.74438 5.86263 15.1368 -4.04832 25.5486 -0.431769 +480 2 9.80341 6.81631 13.907 0.113844 6.0265 -0.426062 +481 1 15.2789 4.31862 10.7553 12.937 12.8557 31.6205 +482 2 16.1415 3.96953 11.0436 -5.39931 0.983411 -21.2391 +483 2 15.1479 4.98349 11.4601 -8.5537 -3.88808 -14.9921 +484 1 11.2581 6.18474 0.159508 31.1076 25.8623 9.85053 +485 2 11.549 5.31982 18.5294 -8.46095 -20.0483 -6.31791 +486 2 10.3153 6.29854 0.132928 -17.8901 -6.88616 -7.00405 +487 1 -0.015613 11.3989 15.0155 5.52071 0.0143375 15.3818 +488 2 18.1286 11.6803 14.2478 -6.84029 3.18322 -8.47428 +489 2 -0.24984 12.0811 15.6717 7.42423 -4.02873 -7.86488 +490 1 7.04792 9.26093 7.28081 24.8295 12.5521 -3.74072 +491 2 6.59027 8.49663 7.6071 -13.7147 -18.0719 7.78469 +492 2 7.98742 9.01504 7.31689 -8.33941 1.9664 -1.88331 +493 1 18.3308 15.3469 12.3202 -6.03602 -2.26652 6.8961 +494 2 0.60478 15.4762 12.0772 12.6515 4.5696 -6.24084 +495 2 17.7927 15.7945 11.6538 0.941578 1.81095 -5.33876 +496 1 16.5149 4.38922 5.26132 -0.591505 19.7601 -54.4807 +497 2 16.8056 3.98806 6.0517 15.8153 -15.5532 32.6352 +498 2 17.2724 4.45951 4.61195 -16.46 -3.71476 24.2381 +499 1 17.705 3.15738 10.7395 -3.58994 -28.0349 -4.43916 +500 2 -0.0357658 3.31586 11.0143 13.799 7.93723 3.46651 +501 2 17.7252 2.25587 10.3433 -5.09014 14.337 3.42017 +502 1 12.282 -0.0102014 10.1171 1.80463 -26.6374 -6.99772 +503 2 11.3739 0.250254 10.2263 -16.4794 9.03176 6.86793 +504 2 12.791 0.759276 10.3145 17.2573 22.9944 3.87451 +505 1 10.3906 9.77529 12.4736 -11.6246 -18.6488 -11.2601 +506 2 11.1162 9.76462 13.0993 9.33947 3.77576 6.26492 +507 2 10.2448 8.81959 12.3007 0.540403 13.8663 1.27912 +508 1 0.620737 2.80838 7.04076 1.85552 -26.9198 -9.07562 +509 2 0.56001 3.58776 7.58035 -0.0658531 10.9425 14.6075 +510 2 1.10446 2.13014 7.5549 -9.15748 13.0523 1.42789 +511 1 0.330306 15.2957 6.90187 -7.34135 39.0889 57.248 +512 2 0.64916 14.9551 7.78023 -6.58887 6.78122 -17.5325 +513 2 0.549392 14.6745 6.26262 18.9985 -47.7984 -33.3782 +514 1 17.0475 6.9988 15.1595 3.61332 2.27156 3.35689 +515 2 17.7695 7.63103 15.0486 -1.58895 3.22527 -3.41358 +516 2 17.4554 6.32111 15.7084 -3.97121 -9.30147 -1.03946 +517 1 9.1229 12.4841 8.04245 42.4716 -17.0961 -6.2748 +518 2 9.3803 11.751 7.44403 8.89783 14.9312 6.88846 +519 2 8.20686 12.4452 7.97952 -55.5673 6.80073 1.54221 +520 1 1.25348 1.79037 2.92813 -6.45569 8.99744 5.64127 +521 2 0.618969 2.05555 2.26044 -0.811293 0.804254 -10.1384 +522 2 1.53437 2.62736 3.32834 8.32683 -8.65344 1.50874 +523 1 4.08283 15.132 9.84955 18.6585 -7.67887 -4.13383 +524 2 4.13303 15.3467 8.91064 -4.64689 1.73023 -5.13685 +525 2 4.95775 14.7288 10.0227 -10.2431 6.10486 1.39562 +526 1 7.30601 2.19422 14.6517 -6.95706 -8.0865 3.71032 +527 2 7.17746 1.61632 13.8834 -0.940722 6.01065 3.73041 +528 2 7.50104 3.06853 14.3169 9.18921 6.42869 -7.97623 +529 1 18.506 14.6308 2.17255 -30.1365 -0.614545 -1.61255 +530 2 0.727688 15.0378 2.26332 7.05 8.92743 1.17189 +531 2 17.7886 15.3173 2.20949 19.3309 -8.24877 -2.15246 +532 1 9.97566 2.72581 12.9114 -11.2099 12.673 12.9937 +533 2 9.86165 2.06107 12.2382 3.86591 -12.7401 -14.4562 +534 2 9.16654 3.26167 12.8314 9.11555 0.77907 4.27596 +535 1 2.93178 8.92582 13.081 1.70152 2.66119 1.53014 +536 2 3.14805 9.86555 12.9479 4.31652 -6.20308 -1.56758 +537 2 3.73073 8.51399 13.4597 -8.92719 0.122715 -5.32652 +538 1 3.2497 8.49808 3.73135 7.7637 26.6897 -66.399 +539 2 3.59457 9.35475 3.3251 -8.07179 -35.8245 7.88572 +540 2 3.32757 8.66083 4.63283 0.688531 4.50937 55.9505 +541 1 5.66796 7.21231 8.59238 -0.641232 -8.3741 -2.33168 +542 2 5.55885 6.25431 8.52804 10.6614 2.37054 -1.78385 +543 2 4.98671 7.4468 9.22816 0.961703 9.61661 1.51464 +544 1 14.8738 1.42122 1.93778 -12.939 -8.09002 14.9013 +545 2 14.5066 2.19936 2.41013 13.5309 -5.26917 -12.7438 +546 2 15.3961 1.64306 1.16722 2.80937 13.5796 -4.98575 +547 1 8.4154 15.1394 0.773463 -1.23857 3.93157 -9.75401 +548 2 9.15191 15.1483 1.39458 4.79594 -7.97678 6.77178 +549 2 7.72939 14.5584 1.13871 1.01453 -0.106788 3.48853 +550 1 15.5631 1.364 7.19799 20.5383 14.1474 18.9399 +551 2 14.9704 0.811359 6.72127 -20.082 -15.4085 -14.9718 +552 2 15.0111 2.04928 7.59859 -2.39038 6.78983 -5.63995 +553 1 5.04086 13.0229 18.4653 -16.526 -4.40388 -18.1368 +554 2 5.51186 13.0765 0.64315 8.46246 3.02378 17.117 +555 2 5.66208 13.3388 17.7987 -1.33855 -1.44241 4.73678 +556 1 15.3891 8.54048 18.1286 -6.10206 -9.0298 20.9903 +557 2 15.6702 9.06907 17.396 9.32842 15.5064 -17.6225 +558 2 15.3407 9.15597 0.239346 -3.25407 -2.5962 -5.00154 +559 1 12.0788 3.07289 18.3192 12.549 -10.6185 1.49283 +560 2 12.5729 2.60825 0.359083 -9.10594 9.02489 11.6275 +561 2 12.4194 2.60778 17.5512 -7.87867 2.96301 -9.52933 +562 1 13.1665 12.6793 5.14706 7.93439 -3.9476 12.1924 +563 2 13.7696 11.9755 4.86963 -4.91093 -2.83846 -5.3825 +564 2 13.2489 12.6724 6.11347 -1.2685 5.53825 -1.32442 +565 1 6.04116 7.20215 0.12064 7.04453 6.18255 -12.3628 +566 2 5.83851 8.12748 -0.154348 1.72696 -16.7644 14.2262 +567 2 5.20617 6.73813 0.252386 -0.898724 4.83199 2.26117 +568 1 17.6547 15.8889 14.9543 35.0528 -4.14946 21.8068 +569 2 16.7907 16.2722 15.0644 -14.9966 1.76464 -15.1201 +570 2 17.9353 15.7106 14.0428 -17.4402 7.26196 -6.43436 +571 1 13.1733 0.917277 16.6395 -12.3557 8.76343 2.76166 +572 2 14.0527 0.785776 16.9891 12.1183 -2.33791 -0.0845054 +573 2 12.8033 0.0287439 16.599 0.155899 -2.85039 -4.8341 +574 1 10.9713 14.5555 7.36537 -14.2255 -14.9035 9.86762 +575 2 10.1709 14.1495 7.79489 23.622 7.7433 -12.5051 +576 2 11.716 13.9517 7.54396 -5.74804 5.50666 -0.0050929 +577 1 17.5337 8.50243 2.08938 -5.40396 -31.7286 -5.54565 +578 2 16.6651 8.377 2.51924 11.1588 5.07358 -2.60802 +579 2 17.6234 7.66639 1.54889 -0.0314299 30.6214 9.39113 +580 1 12.3599 7.90174 1.98937 3.23567 -16.3128 -6.49447 +581 2 11.7961 8.65526 1.85661 -2.62113 17.411 2.96359 +582 2 12.056 7.28247 1.30894 3.22552 -0.339632 3.88847 +583 1 11.9987 14.6627 10.3756 12.942 21.9862 15.1728 +584 2 12.1481 13.8459 9.95801 9.02096 -31.6093 -18.7525 +585 2 11.0572 14.7574 10.3761 -24.4084 6.55121 -1.49817 +586 1 6.83545 6.97591 15.5496 -11.1581 -18.4558 -7.96595 +587 2 7.75433 6.91064 15.3306 20.697 -3.79434 -9.10488 +588 2 6.829 7.75126 16.0755 -7.29309 23.7102 19.2635 +589 1 8.01446 4.61093 13.3684 -42.1501 -10.3174 -21.1074 +590 2 7.18404 4.82769 12.8493 26.4504 -9.34552 12.0218 +591 2 8.34807 5.45326 13.6307 9.05324 16.4922 6.04122 +592 1 13.4266 12.1814 14.3212 -6.42777 -0.785601 -11.9683 +593 2 13.0158 11.3184 14.1828 2.17743 -6.12306 4.21948 +594 2 13.8675 12.3621 13.4761 -0.124998 4.48227 1.48561 +595 1 14.6825 9.43166 7.27492 9.85972 28.3832 27.9741 +596 2 15.5174 9.92891 7.46534 -14.0141 -13.1604 -8.13985 +597 2 14.0576 9.79435 7.94424 7.51867 -12.8522 -19.303 +598 1 12.7091 16.9592 3.18265 16.188 -54.3303 -7.24671 +599 2 12.7269 17.2341 4.07879 2.36138 14.6014 27.6129 +600 2 12.279 17.6213 2.6979 -21.2589 39.1636 -23.5451 +601 1 1.03636 7.13727 17.3765 4.75158 -4.20474 15.7377 +602 2 0.172257 7.41544 17.719 4.25282 -10.0113 -2.57097 +603 2 1.1139 7.5113 16.5007 -3.03142 8.85376 -8.54904 +604 1 12.882 5.00728 15.6915 -13.3168 2.35737 2.40623 +605 2 13.5933 4.38686 15.8029 14.6532 -13.0711 -0.480408 +606 2 13.3236 5.8608 15.7721 -0.35756 9.80313 -2.71263 +607 1 2.42233 3.36085 5.14652 -1.4819 -20.4954 -28.2661 +608 2 1.78479 3.2289 5.83557 -10.283 -5.3637 15.3955 +609 2 2.79623 4.21009 5.29825 15.429 26.5106 10.9541 +610 1 8.29403 11.1124 13.578 -10.7346 17.3121 -71.8204 +611 2 8.44225 10.8317 14.4188 2.94407 -17.9634 86.1576 +612 2 9.02074 10.6663 13.1421 6.44484 1.50589 -14.4967 +613 1 12.9406 1.47026 13.2897 0.354478 -37.8914 22.4103 +614 2 13.6523 1.40022 12.6671 11.2026 2.70228 -18.849 +615 2 12.6313 2.34545 13.2159 -11.96 35.388 -6.53093 +616 1 6.51021 13.5896 2.17003 14.8824 -7.80817 -21.2989 +617 2 5.87965 13.8406 2.83705 -10.6705 6.78718 16.3658 +618 2 7.14425 12.9838 2.58896 -6.69863 7.51381 1.45504 +619 1 15.9112 6.50963 12.6885 16.1371 8.47906 -9.98075 +620 2 16.4229 7.02402 12.0187 -10.4906 -13.771 14.0264 +621 2 16.4535 6.54884 13.5054 -11.4677 1.21509 -6.34034 +622 1 16.8027 0.705691 9.58115 1.1294 19.8318 -8.72086 +623 2 16.927 18.412 9.70296 -4.50862 -18.5326 4.35013 +624 2 16.4766 0.834017 8.66778 -1.09927 -3.21438 5.98018 +625 1 6.10776 11.6244 8.30817 -7.08025 31.3016 10.3571 +626 2 5.31117 11.3633 8.78813 -2.85933 -0.839224 -1.79107 +627 2 6.50869 10.8152 8.04097 10.2317 -24.1838 -9.43106 +628 1 2.82434 8.71866 0.367104 27.0695 8.27339 20.5452 +629 2 2.22535 8.20379 18.5266 -22.1964 -28.7808 -30.261 +630 2 2.24775 9.38106 0.731441 -2.19807 14.7641 10.188 +631 1 10.1092 10.4559 6.56308 -0.703462 -11.3062 5.02538 +632 2 10.4957 9.70218 7.03882 1.80116 3.11275 -0.176711 +633 2 10.5447 10.4553 5.70619 3.2422 0.610478 -8.25928 +634 1 6.77867 15.7679 6.62657 -1.68281 -11.8864 -9.65654 +635 2 7.19346 15.995 7.46341 4.74707 6.17504 0.549944 +636 2 7.26738 16.2069 5.90636 -4.84487 7.71134 8.89334 +637 1 6.4599 12.9833 5.69613 7.9309 12.6721 2.99822 +638 2 6.6611 13.9194 5.88765 -3.42976 -10.7335 1.27405 +639 2 6.10779 12.6203 6.51977 -0.735551 -2.83601 -1.42622 +640 1 16.7784 12.5316 9.7686 6.64513 16.9355 2.79564 +641 2 16.9553 11.9755 9.0112 -1.14761 -14.6768 -5.4217 +642 2 17.3143 13.3158 9.58219 -8.26404 -2.19889 6.01862 +643 1 6.14902 2.92407 2.76687 9.25618 8.55881 7.16487 +644 2 6.44579 3.84137 2.53376 -9.69316 -20.3131 -2.03165 +645 2 5.73381 2.47389 2.01355 1.00911 7.28801 -3.60537 +646 1 10.8507 3.14979 3.2526 -8.20022 -5.11042 -1.435 +647 2 10.2526 3.87795 3.44424 2.28516 4.24005 3.08111 +648 2 10.4324 2.67577 2.52169 3.50832 1.84172 1.62718 +ITEM: TIMESTEP +60 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.82699 6.8727 17.8888 7.11742 1.34647 0.262135 +2 2 7.99 7.13914 18.2565 -12.0864 4.19935 8.4109 +3 2 8.62901 6.07007 17.4227 -0.244169 -11.025 -10.1388 +4 1 18.7394 8.29949 6.7561 2.34576 -2.93089 -42.9257 +5 2 0.440553 7.9626 5.87052 -19.1153 18.5732 27.9896 +6 2 0.571955 7.78688 7.39134 9.59653 -12.4008 18.4821 +7 1 8.51178 18.783 6.87295 -6.05415 -5.58023 12.25 +8 2 9.39304 0.279078 6.53812 12.1519 1.3365 -4.9205 +9 2 7.9628 0.741428 6.37316 -1.87647 6.654 -3.74148 +10 1 6.53357 1.7197 11.6944 -32.7429 -8.61455 3.24653 +11 2 5.73579 2.18358 12.0739 27.4882 -10.0969 -10.5409 +12 2 6.18445 0.855878 11.3477 8.95005 26.2974 10.8481 +13 1 6.96535 5.62987 2.3961 35.6431 -32.0928 -15.0783 +14 2 6.38293 5.93218 3.05619 -24.6612 16.4463 30.6134 +15 2 6.84916 6.21974 1.66578 -5.97717 13.8881 -18.7681 +16 1 16.1974 10.2298 16.1222 0.837184 6.4903 1.28091 +17 2 17.0743 10.6189 16.0747 2.49014 -9.13099 -5.48379 +18 2 15.6463 11.0038 16.2733 -2.87215 -2.05097 1.79245 +19 1 10.6702 14.9469 2.31164 21.9083 12.0632 13.3283 +20 2 10.6818 14.2862 3.02723 -4.43621 6.7471 -1.73288 +21 2 11.263 15.6645 2.64965 -13.2726 -10.9824 -6.65814 +22 1 17.1701 8.22403 10.7142 -10.4028 1.03109 3.96163 +23 2 16.5672 8.79102 11.2349 7.05768 -1.94337 -2.70487 +24 2 17.9333 8.77716 10.499 4.44622 1.4788 -2.07857 +25 1 14.6797 15.9035 16.4693 -22.461 3.39408 -16.7947 +26 2 13.7484 16.2021 16.2951 24.3498 -9.2952 11.1 +27 2 14.6463 15.3225 17.2482 2.4047 10.3841 -3.14234 +28 1 12.1037 13.3669 0.54665 -3.27844 11.868 -6.89748 +29 2 11.8248 13.5865 18.2899 5.63772 -9.83511 -2.25753 +30 2 11.6388 14.0254 1.08354 0.310925 -7.08728 5.11983 +31 1 9.3344 5.48343 3.92748 33.8763 5.32583 -18.4372 +32 2 8.84687 5.22044 4.68611 -23.4915 -4.94858 24.7343 +33 2 8.7079 5.56619 3.20676 -14.265 -0.820383 -3.61874 +34 1 1.71101 4.06482 11.6122 14.6912 -29.1046 6.03323 +35 2 1.58258 4.96723 11.8918 -1.25551 20.6962 3.43651 +36 2 2.34968 3.65386 12.2459 -15.6865 7.58906 -11.285 +37 1 2.0576 6.82445 8.24528 12.7796 11.6573 13.2587 +38 2 2.61911 7.2356 8.94539 -14.081 -6.70064 -12.0447 +39 2 1.89349 5.9205 8.55263 1.83531 2.80349 -1.77694 +40 1 5.39864 4.45401 7.95786 1.68333 5.33174 7.59028 +41 2 5.55249 3.50745 7.87389 -3.64833 -7.88894 -5.24716 +42 2 4.83854 4.74959 7.2381 -8.525 -1.92619 -10.156 +43 1 3.30216 2.93412 17.4505 12.3495 -29.8256 -18.8762 +44 2 3.92727 3.3713 16.8479 -0.637689 -1.64749 6.41076 +45 2 2.89532 3.6118 17.959 -11.8167 26.1488 16.8317 +46 1 7.4312 5.4352 6.15055 3.3909 -0.433751 -53.1737 +47 2 7.92374 5.97877 6.73644 15.9967 14.3411 25.9486 +48 2 6.95714 4.77392 6.61797 -10.969 -14.5624 25.0012 +49 1 9.79304 6.98632 12.0044 -11.2776 3.50532 -30.3595 +50 2 10.3262 6.37648 11.4616 -6.26095 5.52929 9.55968 +51 2 9.10346 7.3395 11.3719 14.604 -9.64535 21.0978 +52 1 14.0819 3.68689 8.0984 5.37498 8.43639 24.1843 +53 2 13.9041 4.52495 7.65095 -1.63712 -2.30615 -0.914734 +54 2 14.2511 3.92795 9.04472 -1.39906 -3.736 -24.3353 +55 1 4.49163 17.2405 3.95076 10.4122 -13.5126 12.545 +56 2 5.41424 17.4498 3.85674 17.5711 4.37719 2.71306 +57 2 4.10795 17.4238 3.10711 -15.6864 12.0721 -17.6618 +58 1 16.4063 16.5742 10.3304 -30.4876 -1.09383 10.2792 +59 2 15.5552 16.587 10.8552 23.7267 -0.690427 -17.666 +60 2 16.1781 16.1401 9.48726 -2.06021 -0.342568 9.10707 +61 1 2.01216 4.81629 0.267482 -15.744 -7.33716 -25.0709 +62 2 2.32092 5.21812 1.07081 12.8803 9.20197 12.7852 +63 2 1.84588 5.54667 -0.35429 -3.07657 2.24499 6.46529 +64 1 11.4525 13.2643 16.3577 0.360612 25.402 13.2121 +65 2 11.0472 12.4174 16.5451 -7.76012 -9.6277 -2.94397 +66 2 11.9986 13.1376 15.5855 6.89063 -5.57893 -10.2697 +67 1 10.1527 10.9848 16.8633 -20.103 19.6526 2.73515 +68 2 10.5885 10.1542 16.8545 15.6291 -29.738 -2.50548 +69 2 9.22545 10.7635 16.7018 -0.592014 4.00252 0.856412 +70 1 11.7907 17.4531 13.47 6.77179 16.9038 -5.30963 +71 2 12.2429 16.8403 12.875 5.23267 3.61287 1.34276 +72 2 12.1771 18.3441 13.2664 -10.6628 -13.9509 7.62196 +73 1 6.44648 9.35189 12.2088 11.1766 16.4313 12.1054 +74 2 7.06476 9.1188 11.5034 -9.94127 -5.08631 1.40965 +75 2 6.99588 9.90362 12.7958 -7.62877 -4.94562 -4.27954 +76 1 16.2706 12.8594 2.68209 -1.75731 9.60563 4.91889 +77 2 17.1141 13.3556 2.57766 -16.4869 -7.21292 0.814827 +78 2 15.5397 13.5204 2.75856 19.4288 -8.85346 -2.79343 +79 1 0.706006 12.6575 5.91598 14.3848 1.31093 7.35726 +80 2 1.05127 12.3982 5.06653 10.4666 0.953953 -14.2919 +81 2 18.4268 12.7017 5.73438 -31.2224 -1.2993 2.30782 +82 1 5.26466 16.4058 18.4218 -16.1073 15.9927 3.08559 +83 2 5.67174 15.6665 17.9813 11.5666 -13.4602 -0.82172 +84 2 5.61268 16.4896 0.669718 7.09967 -3.66518 0.290508 +85 1 0.630514 7.71832 4.14439 -40.0144 -22.0429 16.8318 +86 2 18.6762 8.08291 3.48621 -5.56982 2.47832 -6.04635 +87 2 1.47362 7.93412 3.82987 48.6931 13.8203 -16.755 +88 1 3.15187 8.95984 6.48267 23.8542 8.38798 -14.0929 +89 2 3.71388 8.45844 7.06344 9.53544 -4.30832 6.22463 +90 2 2.31458 8.97258 6.8974 -32.9047 0.579586 11.7619 +91 1 7.26503 10.3427 16.2788 17.1997 0.0580756 -23.1821 +92 2 6.56569 10.7121 15.7432 -4.58149 2.66195 0.233626 +93 2 6.94547 10.3415 17.17 -9.40627 -4.59594 18.3856 +94 1 11.082 0.946861 5.00581 6.19269 9.74659 5.8053 +95 2 11.2852 1.82567 4.65658 -6.55006 -0.520752 -0.877191 +96 2 10.8571 0.430046 4.22808 -5.9868 -5.86677 -2.53499 +97 1 4.345 2.8292 13.2132 -1.27186 28.7368 -8.62995 +98 2 4.51529 3.21096 14.0791 1.17168 5.0352 0.572822 +99 2 4.2316 1.91147 13.3845 -6.13817 -32.6591 5.85186 +100 1 8.38376 10.2307 1.79685 4.09005 3.74222 -19.3624 +101 2 8.31491 10.9253 2.45197 -4.24337 3.92137 10.2746 +102 2 8.66929 9.45546 2.26885 2.27917 -12.8064 10.4703 +103 1 10.3305 1.70894 15.5022 6.01592 -1.55552 8.18831 +104 2 11.2875 1.57757 15.6324 -10.5356 -0.805047 -6.9053 +105 2 10.1546 1.87921 14.5629 5.4285 2.19916 1.25738 +106 1 2.65797 12.824 7.8537 2.67737 0.310449 -2.88199 +107 2 3.19441 13.4775 7.37699 -0.834696 -1.21778 5.43137 +108 2 1.94106 12.6113 7.24505 -1.36647 0.43678 -0.0339739 +109 1 3.78494 11.7026 5.05983 17.7759 13.7966 10.32 +110 2 3.63161 10.9725 5.64962 -3.29006 -9.81966 6.20688 +111 2 3.00915 11.823 4.52928 -13.3129 -0.91097 -10.8894 +112 1 6.77794 14.436 16.9596 -4.81268 9.99067 -5.99614 +113 2 7.54793 15.0018 17.1111 -0.926912 -4.93073 -4.17577 +114 2 6.38498 14.6674 16.0968 9.73202 -0.180074 3.30595 +115 1 14.2221 14.5157 3.27778 -13.9298 6.06594 9.9851 +116 2 13.8151 15.3779 3.06073 2.11094 -9.8452 8.88116 +117 2 13.8089 14.1856 4.11 4.80477 6.02161 -17.3229 +118 1 8.54544 18.1123 16.0497 -51.2002 16.193 -5.03192 +119 2 8.97127 17.2819 16.1484 30.3531 -21.0569 10.3371 +120 2 9.10378 0.243275 16.0887 21.8256 4.58901 -4.15396 +121 1 4.6724 1.65079 4.89395 -0.428695 -35.2982 26.3678 +122 2 3.9342 2.19791 5.10489 -21.2256 11.2309 2.3914 +123 2 5.17375 2.14476 4.28849 23.1392 22.1006 -30.0951 +124 1 14.9936 12.6291 16.4673 -19.77 11.4375 -24.1827 +125 2 14.4795 13.0601 17.1383 2.64859 2.32978 20.7439 +126 2 14.3496 12.6271 15.7247 18.4778 -8.83273 3.74622 +127 1 15.7172 18.4491 16.8771 -38.7365 1.31848 -37.9731 +128 2 16.4119 18.3751 17.4758 43.0193 1.36234 40.9307 +129 2 15.3332 17.5625 16.8778 1.44654 -2.1141 -5.88546 +130 1 1.31769 1.23679 16.6144 -6.54563 -5.62507 -9.64947 +131 2 2.12749 1.70533 16.7963 11.1847 9.69542 4.67012 +132 2 0.698368 1.60678 17.2434 -6.22801 1.29783 7.94738 +133 1 18.1828 4.42633 15.9571 -10.2445 4.38521 4.02875 +134 2 18.0727 3.95797 15.1342 -1.32851 -5.12675 -7.69371 +135 2 0.442412 4.30859 16.2307 9.57607 0.794437 2.0974 +136 1 12.2114 16.9885 16.1505 19.3184 14.9656 -43.0527 +137 2 11.4192 16.582 16.4369 -30.1172 -13.2398 21.5491 +138 2 12.0643 17.0779 15.1772 3.25614 1.68146 17.8786 +139 1 16.0795 2.58494 18.1555 11.3664 -10.2705 19.274 +140 2 15.8693 3.49863 18.3 -12.3112 17.2654 5.58069 +141 2 15.8977 2.41247 17.2454 -5.4363 -1.34473 -24.067 +142 1 6.67972 13.8354 10.1508 -8.25744 -4.72138 -13.3408 +143 2 6.54568 13.5231 11.0561 -0.87434 -6.75398 -1.82198 +144 2 6.44555 13.1152 9.51962 7.50297 7.52708 13.7797 +145 1 10.1393 18.4632 2.72581 -2.6903 -13.3312 7.25948 +146 2 10.3702 0.440572 2.04373 3.08075 7.1003 -10.4416 +147 2 9.34905 18.0295 2.38643 -2.95732 2.6687 3.95308 +148 1 3.05039 17.7207 6.12428 0.448774 -3.44066 -6.39261 +149 2 2.22716 17.4884 5.64326 9.1847 7.623 2.40325 +150 2 3.74061 17.8548 5.44564 -15.5509 -1.85687 4.81473 +151 1 12.5974 16.8374 7.98109 22.5462 3.91689 -18.138 +152 2 11.9813 16.1063 7.98041 -18.255 -3.99171 0.854341 +153 2 12.4106 17.4726 8.66951 -8.78709 2.06599 13.7307 +154 1 14.8906 15.2874 8.20197 12.2291 6.1037 -1.40009 +155 2 14.0169 15.6824 8.32954 6.14586 6.92547 -6.68196 +156 2 15.3058 15.6925 7.40177 -13.6896 -13.6819 15.1947 +157 1 17.774 18.2462 0.317021 16.5526 -0.292921 -8.65749 +158 2 18.517 17.6459 0.018512 -14.2865 26.6269 11.4024 +159 2 18.1212 0.514643 0.485201 -2.53379 -23.9559 -4.59837 +160 1 0.824062 10.4854 1.38532 29.0751 41.1299 -24.8426 +161 2 0.152225 9.85957 1.54468 -35.7643 -25.6114 8.77961 +162 2 0.463481 11.18 0.764874 10.1431 -20.9883 20.7352 +163 1 1.76832 12.2434 3.3342 -0.376699 -6.62105 -8.54196 +164 2 1.60728 11.5206 2.66813 -0.613387 21.7926 10.4725 +165 2 1.98383 13.0773 2.86566 -4.64348 -14.8628 -2.7215 +166 1 0.631416 17.2455 4.93339 -1.94983 -6.83399 6.66588 +167 2 18.8682 18.1422 4.98859 -2.83763 -23.6492 7.38562 +168 2 0.299607 16.5671 5.5918 8.11627 31.0276 -16.6779 +169 1 1.13057 0.905706 9.36586 -12.3827 -0.18715 22.5068 +170 2 1.31261 0.747855 10.3312 -4.25497 -2.51626 -23.3877 +171 2 0.268645 0.477115 9.21068 10.8181 5.54227 0.850191 +172 1 16.7346 2.37332 13.3038 3.72479 1.84576 21.5886 +173 2 16.9761 2.56684 12.4028 0.0757035 3.67621 -15.1405 +174 2 16.5678 1.42686 13.3713 -2.69734 -3.58003 -5.961 +175 1 2.71222 15.8556 12.0453 -23.2953 18.5694 10.7935 +176 2 3.02055 15.4773 12.8617 6.20357 -6.16654 7.20198 +177 2 3.26455 15.5565 11.3309 7.18341 -3.43964 -7.05157 +178 1 16.426 15.6488 6.1101 -14.7609 -25.4644 9.17481 +179 2 17.2826 15.6571 6.51544 16.1879 -4.44611 5.83009 +180 2 16.438 16.358 5.49538 -5.11113 23.225 -23.4349 +181 1 5.76882 5.13637 11.8122 -12.0704 17.5482 5.11471 +182 2 5.44081 5.9885 12.2003 4.95719 -19.5528 -5.70673 +183 2 5.01212 4.52871 11.8104 6.55972 2.89024 2.61392 +184 1 15.1343 4.86498 0.81249 17.6468 10.3526 -37.7608 +185 2 14.8624 4.60472 1.67155 -6.094 -8.43385 31.413 +186 2 14.42 5.38891 0.454388 -5.76674 3.16257 -0.979918 +187 1 16.354 16.4047 2.01729 -13.9507 10.6217 3.88258 +188 2 15.8491 16.8174 2.76015 19.926 -7.04016 -11.695 +189 2 16.7635 17.1307 1.5183 -3.64457 0.258913 2.52225 +190 1 0.229093 4.84171 3.85636 -16.5361 -39.1535 -9.01102 +191 2 0.280674 5.76384 3.97165 5.27146 43.6678 4.59383 +192 2 0.903367 4.46589 4.41298 10.8 -4.72049 2.86342 +193 1 2.98031 15.0696 15.1724 7.38994 17.2595 -26.1187 +194 2 2.78389 14.6733 16.0132 -4.59533 -4.91572 22.4357 +195 2 2.69496 16.0061 15.2442 -6.09825 -12.2809 0.399162 +196 1 1.14224 14.6486 9.53301 9.69931 -12.3423 3.57818 +197 2 2.08157 14.8372 9.66442 -5.69448 4.03807 -1.75917 +198 2 1.10168 13.6946 9.72739 -6.61933 10.5759 -2.74939 +199 1 13.5148 16.5367 11.5259 11.0739 -5.14125 9.92262 +200 2 13.0998 17.2443 11.0437 -3.0151 15.655 -8.61356 +201 2 13.0781 15.7617 11.1648 3.09342 -5.90037 -0.559148 +202 1 4.6468 1.4492 0.760442 21.9419 17.6404 -6.63386 +203 2 4.03376 2.00221 0.272437 -3.30289 2.18566 -6.21296 +204 2 4.11186 0.849122 1.26962 -7.6403 -10.762 3.4591 +205 1 1.46385 18.5705 11.8684 11.5971 1.37494 19.5738 +206 2 1.40443 0.572196 12.6059 -0.800227 -11.3118 -6.50307 +207 2 2.03902 17.8403 12.1929 -11.6325 11.1906 -9.16825 +208 1 11.4878 10.1514 4.00495 -23.562 -17.5625 40.225 +209 2 11.4445 10.4449 3.12053 -0.0273244 15.9845 -32.1431 +210 2 12.4087 10.0544 4.20335 22.0666 -0.101113 3.57488 +211 1 8.17978 12.1587 3.71493 28.653 -3.15285 -17.361 +212 2 9.01377 12.5671 3.97927 5.41625 0.887106 1.05136 +213 2 7.604 12.3558 4.43149 -23.5411 2.07968 29.6007 +214 1 14.5452 4.04195 3.30356 -17.0528 -5.31405 -8.64237 +215 2 15.1661 4.06926 4.02931 6.41379 4.8272 12.7333 +216 2 13.7233 4.44982 3.62226 2.87412 -0.159853 0.628569 +217 1 5.66111 1.64664 7.53337 47.3068 24.6854 -47.7691 +218 2 4.99385 1.2169 7.99076 -47.8059 -33.9417 34.4755 +219 2 5.55481 1.33937 6.59792 -2.0798 14.2024 17.8553 +220 1 17.8737 1.09537 4.84004 -13.6202 -14.1831 4.02096 +221 2 18.464 1.49436 4.20233 9.91759 7.15437 -5.32228 +222 2 17.8561 1.60546 5.65338 7.58498 6.35358 2.28946 +223 1 6.84561 9.39092 4.51119 3.77645 -4.79561 13.9854 +224 2 6.80242 9.62767 5.4641 3.30223 -6.77647 -16.668 +225 2 7.74702 9.0401 4.34673 -10.1352 5.61637 3.28246 +226 1 2.64818 14.8733 2.0031 -12.6643 -4.21043 8.13073 +227 2 3.39044 14.7832 2.61388 1.60205 1.10943 -1.58393 +228 2 2.93662 15.3311 1.21566 8.61024 -0.712779 -4.79925 +229 1 17.3356 12.9304 13.2091 0.397713 16.5012 -11.0143 +230 2 16.4513 13.2838 13.3976 5.15185 -2.46087 0.53778 +231 2 17.8465 13.7314 12.9621 -7.21788 -13.1567 2.02539 +232 1 14.9178 10.5628 1.45295 0.32879 33.5889 18.189 +233 2 15.3786 11.3985 1.79277 -12.1624 -32.8958 -12.3175 +234 2 13.9692 10.6935 1.62732 12.9477 -1.40805 -3.43718 +235 1 5.70482 6.69167 4.56094 -12.9541 28.0444 -8.31435 +236 2 5.76223 7.67071 4.46331 5.24004 -15.8993 1.97075 +237 2 6.3673 6.43877 5.21208 3.70858 -3.97365 0.601716 +238 1 7.97185 8.33683 10.3069 8.6941 -15.2025 -3.68424 +239 2 8.60404 8.92215 9.84221 -9.13329 -6.11086 -5.89913 +240 2 7.51742 7.70171 9.70626 6.59476 18.8917 -0.227694 +241 1 13.4177 18.464 5.71198 21.9916 6.6123 -14.6219 +242 2 12.6947 0.421284 5.51228 -9.11836 -2.12279 2.23123 +243 2 13.1839 18.0173 6.51737 -9.90438 -14.4062 13.6987 +244 1 0.0221035 2.62655 0.261444 12.6472 -47.1951 11.8456 +245 2 17.7527 2.75577 18.6598 -10.3686 10.7513 -7.61459 +246 2 0.546882 3.40438 0.188377 7.87852 33.0005 -3.15527 +247 1 12.8067 10.9927 9.75832 44.9647 -24.4125 8.46131 +248 2 11.8751 10.9314 9.65932 -31.4773 -7.30673 -3.09024 +249 2 13.1121 10.0761 10.034 -17.0663 24.2241 -8.13324 +250 1 0.673563 12.1459 11.0385 -14.9158 10.2345 17.3916 +251 2 18.3756 12.1565 11.2954 6.68564 0.0119082 -11.299 +252 2 1.10384 12.3853 11.8646 9.18612 4.40652 0.693569 +253 1 5.14721 7.33361 13.3929 15.7357 3.63047 1.84442 +254 2 5.59488 8.13358 13.0475 0.482915 -12.4288 -2.35902 +255 2 5.71887 7.03407 14.1269 -8.93121 6.52874 -3.37327 +256 1 1.18567 6.84505 11.8697 14.6786 34.5125 12.17 +257 2 0.393465 7.21987 11.4553 4.74321 -4.21777 2.31791 +258 2 1.70022 7.64215 12.2222 -16.972 -31.3024 -13.5319 +259 1 15.4816 9.69158 12.3277 9.90347 -39.8653 -1.57959 +260 2 15.3406 10.5924 12.1653 -13.2531 41.4735 -11.5871 +261 2 15.406 9.62533 13.2698 1.46249 -6.23285 16.1579 +262 1 16.5413 12.6347 5.5059 7.75274 -6.4804 14.118 +263 2 16.3104 13.5445 5.70094 -2.97213 12.2972 0.10227 +264 2 16.3923 12.5258 4.56955 -2.98329 -0.0504447 -18.3871 +265 1 6.30461 9.82716 0.0624729 6.72618 23.4574 16.6882 +266 2 5.51437 10.3287 0.304315 -0.069722 -0.440899 2.51054 +267 2 6.96842 10.0501 0.765687 -11.6212 -9.0506 -14.676 +268 1 12.2588 6.10042 4.03099 15.0483 24.7381 -3.94445 +269 2 12.3021 6.98896 3.58767 -5.34003 -28.327 1.95056 +270 2 11.3325 5.86569 4.06669 -11.2394 -4.89225 -2.88949 +271 1 0.336489 12.822 0.136131 -4.0328 -4.68121 -1.73262 +272 2 -0.0692718 13.3776 0.815875 4.64589 5.49593 0.971726 +273 2 18.45 12.9344 17.9884 -7.92492 5.13291 -5.47118 +274 1 3.58866 18.6351 8.62238 -6.65617 9.61834 5.79691 +275 2 3.41901 18.3768 7.70859 0.297411 -7.32139 -0.213682 +276 2 2.71275 0.31261 8.92207 15.7588 -5.16119 -5.17535 +277 1 7.50496 17.418 4.49772 -12.5742 -28.6928 8.65377 +278 2 7.55283 18.3491 4.58726 6.16277 33.1384 2.27358 +279 2 7.74423 17.2559 3.59134 -1.33953 -2.22923 -11.883 +280 1 9.26392 17.1331 12.2129 -23.7136 4.99112 -6.35848 +281 2 9.34774 16.2465 11.866 0.0093118 -9.2577 -7.50778 +282 2 9.98892 17.2487 12.8038 23.7327 3.38143 15.862 +283 1 13.3751 13.0337 7.97577 10.7478 10.6887 -13.5108 +284 2 13.3787 12.2298 8.50206 6.89696 -2.46192 7.10708 +285 2 14.2592 13.4885 8.01338 -22.4634 -9.00878 7.77512 +286 1 14.8592 2.99547 15.3735 -5.27851 1.66435 23.9116 +287 2 14.1885 2.32373 15.2402 -1.63897 -5.65445 -5.41614 +288 2 15.4149 3.00295 14.6023 9.16888 -1.78425 -15.607 +289 1 9.86925 15.6154 16.9672 4.33331 -1.89849 4.26663 +290 2 10.4152 14.8537 16.7052 -6.80597 -3.90746 -0.277805 +291 2 9.57771 15.4416 17.8827 0.419377 0.378738 -9.64067 +292 1 11.2678 8.44973 16.5939 -8.08747 -14.0791 2.0813 +293 2 10.6693 7.85604 16.0792 7.94549 12.4538 10.9378 +294 2 11.4172 8.01973 17.4598 -1.80582 0.647834 -14.6449 +295 1 3.91551 18.1683 16.8005 9.39931 12.2215 14.3903 +296 2 4.49606 17.6509 17.3756 -3.52447 -10.1131 -6.81095 +297 2 3.95318 0.38369 17.2365 -5.94998 0.470214 -7.14863 +298 1 2.19966 4.20574 8.91394 -16.952 6.25086 -28.7566 +299 2 3.11163 4.1112 8.67966 19.1354 -3.54458 -0.459765 +300 2 2.10589 3.95692 9.81579 -0.00585893 -3.49833 31.5267 +301 1 9.86514 10.3731 9.72031 15.6542 -41.5135 2.74879 +302 2 9.61489 11.2182 9.40808 -14.4527 35.546 -8.7168 +303 2 10.0569 10.3888 10.6595 -0.965326 6.48855 10.4451 +304 1 9.65603 0.92083 10.8651 15.4128 -5.93628 -1.69563 +305 2 9.35399 0.0448876 11.1808 -6.92756 10.8331 -8.061 +306 2 9.08478 1.27687 10.159 0.925367 -10.2687 5.27886 +307 1 9.17601 15.08 10.2001 28.4704 15.1584 7.58672 +308 2 8.86011 15.9493 9.94215 -4.94078 5.46469 -8.90142 +309 2 8.40516 14.5378 10.1682 -22.1716 -15.7686 -1.61012 +310 1 0.908908 9.65777 10.2661 1.02783 -39.6886 -13.0526 +311 2 0.968686 10.5462 10.5861 7.37828 17.5094 1.10535 +312 2 1.79128 9.34954 9.98968 -11.6106 9.29057 7.26807 +313 1 16.9796 4.82858 8.10785 29.2892 -10.1291 -25.9715 +314 2 16.4029 5.49318 8.42182 -23.755 22.5857 11.698 +315 2 16.8784 4.07707 8.6652 -3.89501 -13.8815 13.5617 +316 1 14.7893 14.6979 0.173135 5.39554 -7.96858 -12.7144 +317 2 15.0505 15.3823 0.785417 9.36392 5.93735 12.263 +318 2 13.9789 14.3219 0.494521 -15.109 -8.03615 11.244 +319 1 3.74323 11.0124 9.54886 4.38849 -4.14114 10.1409 +320 2 3.63158 11.395 10.4392 1.27308 -1.67175 -3.21468 +321 2 3.24423 11.5652 8.93525 -2.74645 9.31742 -2.2917 +322 1 11.2573 10.7534 1.46897 -2.74628 -20.4518 -2.00657 +323 2 11.6064 11.5358 1.05536 3.45865 20.4344 -8.16659 +324 2 10.3358 10.6724 1.18755 -1.77969 3.26872 -0.743535 +325 1 13.1779 7.19199 12.7182 14.2184 -9.05364 3.75753 +326 2 14.115 6.87295 12.7816 -17.4164 8.42328 -3.38551 +327 2 12.6212 6.40428 12.8017 3.66516 -2.90974 1.8722 +328 1 9.6094 1.86333 0.961036 -1.66559 10.1622 -20.0065 +329 2 8.74982 1.7634 0.476399 21.9169 -1.84649 8.18396 +330 2 10.2659 2.29351 0.366445 -15.6421 -6.48907 5.12748 +331 1 10.6591 13.4925 4.58018 -19.1141 -0.630091 -16.1529 +332 2 11.5305 13.1262 4.70232 12.5696 -8.82773 5.21944 +333 2 10.586 14.1761 5.24203 -0.728557 4.94256 14.6221 +334 1 14.495 1.73909 10.9749 -8.14936 -7.82556 -5.33359 +335 2 15.2253 1.30703 10.5146 2.44721 2.03735 2.44955 +336 2 14.6402 2.68373 10.8341 0.821335 1.15578 7.11863 +337 1 14.5247 12.1307 11.6327 6.29346 4.76638 51.459 +338 2 15.3146 12.4097 11.1999 18.4985 9.73575 -23.8815 +339 2 13.8662 11.9319 10.9987 -20.1843 -8.01501 -29.1382 +340 1 8.1934 5.08514 9.85848 20.6286 -7.50881 -18.2265 +341 2 7.39102 5.12991 10.3666 -14.5844 -3.05188 8.40055 +342 2 8.26178 4.1705 9.49849 -5.86813 14.6103 10.9415 +343 1 1.56363 16.9354 18.4208 -1.17306 -23.9048 5.52961 +344 2 2.13897 17.2639 17.7268 3.56106 5.06395 -9.30964 +345 2 1.54669 15.9596 18.2963 3.84009 16.9778 0.440392 +346 1 1.49268 17.3196 15.3241 -27.5122 8.95969 8.58328 +347 2 1.46041 18.2525 15.6844 -4.86102 -31.3543 -7.55486 +348 2 0.570896 16.9106 15.346 29.8648 20.9529 0.539048 +349 1 3.59911 5.78915 6.06648 9.03859 -15.9659 -5.84137 +350 2 3.1214 6.40715 6.60976 -11.746 7.94276 10.4286 +351 2 4.15987 6.31414 5.47841 1.03618 -2.86439 -0.897012 +352 1 12.5136 9.4824 14.2234 -14.5482 39.9006 11.9441 +353 2 12.9252 8.74241 13.842 20.5687 -36.5434 -22.703 +354 2 12.2915 9.17254 15.1019 -4.72781 -1.84288 9.93497 +355 1 4.05984 15.2792 6.9471 -25.1121 -18.1042 13.4141 +356 2 3.54373 16.0393 6.6659 -0.213909 7.77754 -0.115815 +357 2 4.94872 15.4739 6.70425 29.3053 8.29501 -4.075 +358 1 0.70733 8.67925 15.049 -6.53077 -6.52645 2.33041 +359 2 0.403057 9.59211 15.0995 2.0449 7.24241 -1.44461 +360 2 1.39578 8.67212 14.3782 6.73055 2.7204 -4.7895 +361 1 12.9505 8.27543 10.2426 2.52256 -9.36522 19.2887 +362 2 13.7222 7.81068 9.89429 1.56507 0.683648 -5.24915 +363 2 12.8789 7.88642 11.1491 -0.00217653 14.5673 -16.6218 +364 1 15.3477 7.80216 3.55401 -12.532 5.83489 -12.7989 +365 2 14.4906 7.48222 3.33103 -16.8871 -2.65253 -29.4538 +366 2 15.2947 7.61797 4.46883 25.5814 -3.41235 36.6493 +367 1 17.266 6.70187 0.000674068 12.1195 -8.95496 8.26487 +368 2 16.7457 6.00049 0.395257 -2.87342 -9.15243 0.336143 +369 2 16.622 7.35704 18.4101 -17.4752 15.3525 -8.08793 +370 1 8.88335 6.95399 7.81342 26.8473 24.5973 -5.8387 +371 2 9.80542 7.33522 7.87938 -25.1058 -10.3372 -2.45861 +372 2 8.7714 6.40725 8.58367 -2.11125 -14.3958 16.4377 +373 1 12.3879 0.548843 1.24082 4.42765 -0.472301 -1.45686 +374 2 13.3265 0.730859 1.40339 -2.38609 2.78881 -0.689397 +375 2 12.2563 0.636326 0.292606 2.56041 -5.4085 -0.678049 +376 1 5.63248 15.1125 14.5468 -9.48886 -16.8407 5.02155 +377 2 4.69503 15.2624 14.7723 5.83199 -5.28539 -1.87026 +378 2 5.99589 15.9615 14.314 8.44734 16.7096 -6.42729 +379 1 3.85575 6.39433 1.75493 1.50274 -8.79363 8.51258 +380 2 3.48975 7.20754 1.41538 -8.87879 17.021 -2.96274 +381 2 4.03803 6.55873 2.69128 -1.36395 1.28851 -4.88856 +382 1 3.93631 11.5299 12.3893 -8.10483 -0.317118 -5.66906 +383 2 4.80663 11.9435 12.4577 -3.51298 -1.2689 0.972005 +384 2 3.32279 12.1457 12.8171 1.30391 -5.08042 -1.13556 +385 1 5.30379 3.85961 15.861 3.26535 -66.7729 -21.4105 +386 2 5.99128 3.21668 15.5051 -18.0074 17.9789 14.3955 +387 2 5.71814 4.68422 15.8683 22.7973 48.3912 1.26107 +388 1 14.279 10.1761 4.52146 -28.2637 29.6843 37.5781 +389 2 14.4726 9.82647 5.40905 -2.50301 -0.0307068 -4.88302 +390 2 14.7482 9.65242 3.92054 26.3189 -27.9191 -30.9088 +391 1 7.73542 17.3919 9.15036 20.9187 -26.1564 3.32362 +392 2 6.89787 17.6412 9.51878 -14.391 11.6651 3.78997 +393 2 7.98556 17.9488 8.40931 -4.18052 11.5531 -5.69175 +394 1 4.50439 14.5239 3.99264 11.0977 -23.3764 -48.4991 +395 2 4.56306 15.4325 4.20277 -1.38797 35.5351 15.6514 +396 2 4.31322 14.0314 4.76491 -6.35847 -16.1784 30.998 +397 1 14.1606 7.45193 15.811 -24.1382 -9.56247 -10.586 +398 2 15.0553 7.36431 15.524 24.9604 -3.00047 -8.7167 +399 2 14.2305 7.91189 16.6334 1.28104 8.01927 19.5585 +400 1 2.99693 18.3516 1.90386 -17.8633 -43.3253 -26.4279 +401 2 2.47403 17.7132 1.31624 19.6124 26.5697 18.0429 +402 2 2.33007 0.205152 2.36966 -11.145 11.7012 10.1025 +403 1 8.00896 1.59538 4.54643 -14.6935 -3.1209 6.18761 +404 2 7.42733 1.99671 3.8763 8.34922 -0.442348 -1.34208 +405 2 8.90764 1.54031 4.21745 2.64121 3.0498 -7.75206 +406 1 2.41984 14.15 17.6911 38.7391 17.8224 -8.42313 +407 2 1.65201 13.6768 17.9262 -26.9962 -21.4224 14.4939 +408 2 3.15619 13.6354 18.0755 -0.305296 5.75785 -2.4818 +409 1 0.881322 1.80893 13.8899 -12.9164 4.63859 7.1799 +410 2 0.998981 1.67187 14.8549 -5.47541 -0.367675 -15.7697 +411 2 18.568 1.96442 13.7158 18.7475 -1.65173 8.16576 +412 1 4.35626 0.108756 13.8915 -10.9503 4.16473 7.68997 +413 2 5.20313 18.36 13.6952 15.0207 -4.30703 2.98167 +414 2 4.18562 18.5651 14.8318 -0.53115 -1.77986 -5.89667 +415 1 7.21985 0.783193 18.3638 -3.94277 -6.88163 -25.1551 +416 2 7.12969 0.383485 17.4575 9.77138 9.98351 24.3944 +417 2 6.41237 1.28912 18.5059 -6.03182 -4.67978 5.08395 +418 1 15.9996 18.4041 13.9383 18.1315 -1.4443 -10.5581 +419 2 15.071 18.4425 13.7445 -14.3326 2.53282 3.85714 +420 2 16.1651 18.6473 14.8506 -8.9044 -3.87569 12.2679 +421 1 10.1939 4.54115 16.2821 35.3159 -4.68875 2.87762 +422 2 11.1919 4.40884 16.3129 -34.2522 14.5881 -3.55905 +423 2 9.86192 3.67371 16.0442 -3.43039 -7.24249 -0.81883 +424 1 15.9323 17.7355 4.44233 22.6638 -20.6434 -12.8847 +425 2 16.5412 -0.18272 4.5755 6.4476 10.7336 -1.45992 +426 2 15.0915 18.0468 4.70328 -34.4096 13.9436 14.4512 +427 1 6.99117 17.4686 13.8836 -42.0334 -7.7574 -17.1448 +428 2 7.47631 17.7428 14.6303 20.6357 14.1189 34.523 +429 2 7.65356 17.3815 13.215 15.8945 -3.28854 -19.4769 +430 1 13.2291 6.49408 6.5607 17.0277 2.09005 0.593761 +431 2 14.1816 6.76782 6.52286 -25.3304 -6.60509 -4.73803 +432 2 12.9166 6.35235 5.64754 5.89534 0.461784 7.57918 +433 1 7.85324 2.32148 9.35275 5.46391 6.9162 26.9577 +434 2 7.3686 2.17076 10.1976 2.69269 5.61176 -14.2633 +435 2 7.26481 2.08775 8.6472 -14.0957 -9.57593 -14.6111 +436 1 15.2023 14.7793 13.7187 7.74208 -16.2001 -4.59991 +437 2 14.8319 14.9596 14.5759 -4.08925 6.59301 14.3355 +438 2 15.0747 15.5488 13.1771 -7.6118 10.0658 -7.58078 +439 1 9.41047 8.32341 3.83123 -6.47708 13.1987 -5.34522 +440 2 10.2452 8.80483 3.85219 3.73168 3.01968 4.76716 +441 2 9.63137 7.40393 3.95808 -1.29777 -11.5098 0.542939 +442 1 17.7649 13.5922 16.3898 -11.4367 -25.6902 16.7919 +443 2 16.7908 13.5407 16.3666 6.32242 -2.67761 -0.626712 +444 2 17.9873 14.3645 15.8914 0.275374 22.0623 -11.5119 +445 1 4.92213 10.5724 2.8597 -4.83644 2.51404 -15.3254 +446 2 5.59736 10.2151 3.4378 8.5726 -2.027 3.49443 +447 2 4.66951 11.4171 3.23999 1.02108 -1.77966 3.70944 +448 1 3.74742 8.38157 10.0278 -2.2319 9.94706 -11.0912 +449 2 3.89489 9.30484 9.7273 -4.74563 -10.9217 8.16333 +450 2 3.84233 8.40088 10.9831 -0.997449 0.744123 6.62097 +451 1 15.9666 6.96875 6.01253 -14.8276 15.8227 3.08109 +452 2 16.7817 7.37259 6.30064 12.9112 7.94175 5.43996 +453 2 16.2196 6.12219 5.66656 5.41287 -21.5059 -0.527712 +454 1 15.1391 7.15478 9.02923 3.95319 -30.3017 38.192 +455 2 15.9165 7.52141 9.44882 9.73374 3.98045 10.059 +456 2 15.0698 7.60427 8.22918 -5.81948 28.1077 -46.3627 +457 1 6.22822 12.9188 12.7298 1.31868 -8.19268 -13.1839 +458 2 6.88351 12.2656 13.01 8.10485 3.82836 6.8834 +459 2 6.11855 13.5785 13.4162 1.19396 9.04898 12.3458 +460 1 12.1253 4.52441 13.1066 -23.5121 -14.293 -11.093 +461 2 12.4631 4.60406 14.0095 -9.44452 -2.69015 3.06865 +462 2 11.2831 3.97256 13.0795 31.8956 18.265 6.80246 +463 1 11.4055 8.12657 7.94639 -16.7563 2.96014 -17.3287 +464 2 11.9383 7.50834 7.43372 10.7385 -1.00284 -0.366803 +465 2 11.8652 8.24712 8.77366 5.83315 -1.26494 14.2429 +466 1 17.1037 10.8819 7.56719 -22.1575 4.54299 3.0458 +467 2 17.7705 10.2842 7.28531 25.0286 -24.4015 -2.83309 +468 2 16.8908 11.3655 6.76798 -3.05919 12.9941 -4.73253 +469 1 5.25302 18.1256 10.9232 26.818 -0.191878 -4.18594 +470 2 4.8269 17.8089 11.6994 -14.1597 -10.1429 18.6642 +471 2 4.64144 17.9747 10.2197 -19.8227 3.49229 -23.3423 +472 1 7.59833 17.4619 1.74995 8.37542 2.1771 -36.4257 +473 2 8.02215 16.748 1.21035 -16.0406 12.4022 13.5887 +474 2 7.374 18.1677 1.08602 7.01745 -13.9463 17.8331 +475 1 1.92633 12.907 13.6044 0.0880561 -5.46821 -16.7511 +476 2 1.47807 12.3822 14.2652 -4.39349 -7.86198 7.054 +477 2 2.32754 13.632 14.072 3.07665 17.0427 10.8635 +478 1 9.50987 6.80039 14.836 2.18935 -20.8269 12.8739 +479 2 9.79082 5.96037 15.3114 -4.54962 20.4196 -21.9392 +480 2 9.66995 6.7436 13.8735 6.47407 0.337666 8.03802 +481 1 15.2827 4.32341 10.7768 10.307 9.68599 -4.89646 +482 2 16.2397 4.0919 10.6916 -21.0983 9.39835 9.69703 +483 2 15.2266 5.10894 11.3663 5.46907 -15.4805 -5.79884 +484 1 11.3016 6.20596 0.140794 12.6043 6.09542 0.747046 +485 2 11.4786 5.29078 18.6344 12.8703 -22.3778 -2.75052 +486 2 10.381 6.25156 -0.0726873 -21.1699 14.4442 -0.985902 +487 1 -0.0715916 11.4097 14.9721 22.1692 -7.15633 35.3796 +488 2 18.1992 11.7732 14.1947 -21.0416 8.6568 -29.4322 +489 2 -0.201181 12.1402 15.5966 -0.594523 -4.50066 0.166015 +490 1 7.04588 9.27411 7.30476 9.145 16.929 -11.701 +491 2 6.64583 8.45304 7.57308 -6.76023 -15.305 10.0219 +492 2 7.98749 9.10222 7.20319 2.10913 -2.81405 2.65036 +493 1 18.3255 15.3308 12.2943 -10.9271 3.22482 1.76971 +494 2 0.551901 15.6023 12.004 16.2571 0.370549 -2.10144 +495 2 17.7334 15.6802 11.6169 -1.97195 2.58378 -3.71708 +496 1 16.5011 4.39937 5.27673 4.48444 11.2976 -56.5136 +497 2 16.7777 3.84422 5.96849 7.0389 -19.8316 37.8082 +498 2 17.2036 4.29545 4.59204 -6.79319 11.0559 14.2779 +499 1 17.7009 3.16012 10.7623 -11.0785 -13.2259 -8.21854 +500 2 -0.0365931 3.41438 10.9472 14.4195 -1.11458 2.04579 +501 2 17.6933 2.32175 10.2562 4.60522 6.17753 6.57508 +502 1 12.2846 -0.0106908 10.1146 7.09195 -37.1879 -10.2172 +503 2 11.3926 0.256016 10.2673 -25.9358 14.4274 7.98014 +504 2 12.8288 0.732071 10.298 19.2326 28.445 5.65892 +505 1 10.3866 9.75519 12.5017 -6.95633 -10.4248 -20.8372 +506 2 11.1983 9.82383 13.0055 7.4239 -2.70171 9.41801 +507 2 10.3064 8.80301 12.2683 1.05955 14.1529 10.144 +508 1 0.648708 2.774 7.07027 -1.36725 -4.55963 12.8723 +509 2 0.490272 3.61188 7.51443 -2.95105 4.17746 -2.75047 +510 2 1.10621 2.25999 7.75495 -4.79333 -3.92365 -3.87978 +511 1 0.307244 15.292 6.87913 -0.83379 49.2439 44.5727 +512 2 0.652444 15.3347 7.80405 -9.58611 -2.1659 -14.8737 +513 2 0.567348 14.4512 6.61032 15.5663 -52.8882 -22.8213 +514 1 17.056 6.99125 15.1184 -7.99596 0.858836 -4.56633 +515 2 17.7814 7.62276 14.9808 0.742784 -5.19204 3.90514 +516 2 17.4035 6.24942 15.6288 5.94943 -0.679765 0.413052 +517 1 9.13726 12.4999 8.01885 37.0353 0.885775 16.8739 +518 2 9.52568 11.8572 7.39973 -10.6447 2.68521 -0.695331 +519 2 8.21726 12.5875 7.87097 -30.0746 -3.81245 -10.8301 +520 1 1.21553 1.74407 2.88052 -2.59699 -2.39415 1.38589 +521 2 0.835324 2.14494 2.08419 1.70776 2.79001 2.24225 +522 2 1.71989 2.41102 3.3678 0.071784 1.92406 -2.09937 +523 1 4.07628 15.1457 9.88397 17.4433 -7.82557 -1.54586 +524 2 4.111 15.2412 8.92029 0.253189 0.655179 -3.36934 +525 2 4.94389 14.7737 10.148 -8.68797 4.30724 -10.2942 +526 1 7.35101 2.21809 14.6867 -7.35168 5.20952 -5.71558 +527 2 7.12719 1.57839 13.9999 0.606569 0.313122 2.88765 +528 2 7.62455 3.00796 14.1978 2.82745 -2.40467 5.3071 +529 1 18.457 14.6023 2.16488 -22.5257 23.4253 1.52633 +530 2 0.650438 15.0238 2.37846 9.31401 -4.06208 0.652559 +531 2 17.8015 15.3468 2.21006 9.59865 -20.266 -2.54542 +532 1 9.9778 2.69966 12.9163 0.655502 16.6224 11.2027 +533 2 9.96654 2.13525 12.1425 -5.01566 -7.38072 -9.38582 +534 2 9.27217 3.36428 12.8011 2.98946 -10.098 -0.342741 +535 1 2.95791 8.92102 13.0894 10.3197 8.62466 2.37945 +536 2 3.25022 9.8484 12.9226 -2.55555 -16.3803 0.657875 +537 2 3.7553 8.44758 13.4136 -17.8894 4.38499 -5.11642 +538 1 3.26012 8.5452 3.75851 7.68136 4.64814 -61.3797 +539 2 3.65213 9.34274 3.2957 -8.84339 -23.8918 18.3111 +540 2 3.19772 8.72964 4.66662 3.169 13.2307 40.2657 +541 1 5.70723 7.22602 8.61089 15.0471 5.15238 -9.7988 +542 2 5.61347 6.27934 8.4361 -3.3163 0.301479 7.52532 +543 2 4.97449 7.5436 9.15453 0.52499 -8.4302 1.10573 +544 1 14.8706 1.4621 1.8863 1.70998 27.5213 20.9307 +545 2 14.7201 2.23316 2.46749 -8.28585 -15.753 -0.675778 +546 2 15.5631 1.82311 1.33978 3.90729 -10.8233 -20.0391 +547 1 8.4891 15.095 0.746196 -1.67248 3.44686 2.60315 +548 2 9.16152 15.1411 1.43932 5.44244 -6.16758 -2.29782 +549 2 7.78914 14.5375 1.12422 -1.25934 1.00196 -2.01266 +550 1 15.531 1.37665 7.20033 20.0832 14.6351 13.3031 +551 2 14.8916 0.843079 6.76136 -18.4007 -14.9103 -14.8508 +552 2 15.066 2.19014 7.43626 -3.82192 3.26637 1.54172 +553 1 5.03616 12.9919 18.445 -16.5564 -3.92778 -1.34985 +554 2 5.49952 13.0651 0.633359 3.65082 -0.909975 11.8673 +555 2 5.58799 13.4788 17.838 5.35286 -1.67587 -4.32886 +556 1 15.4004 8.57696 18.1096 -13.5133 -17.3986 23.7812 +557 2 15.6963 9.177 17.4428 12.1428 17.8023 -17.443 +558 2 15.2132 9.11981 0.25138 2.83515 1.87454 -5.46736 +559 1 12.0742 3.0873 18.3015 -13.0771 12.9456 1.32203 +560 2 12.4416 2.71193 0.467697 5.19488 -4.15516 -6.31478 +561 2 12.3414 2.59119 17.5164 7.34103 -8.20972 9.84797 +562 1 13.1603 12.6784 5.14975 4.6094 5.88635 0.276196 +563 2 13.6665 11.971 4.72065 -1.49243 -3.38503 8.68718 +564 2 13.2851 12.6103 6.1136 1.29016 -0.295852 -5.09341 +565 1 6.06548 7.22062 0.130395 -10.0215 14.1887 -9.78073 +566 2 5.90478 8.1622 -0.126677 10.3505 -23.4507 13.8616 +567 2 5.20282 6.91875 0.452817 7.86884 -4.47391 0.318594 +568 1 17.6551 15.8705 14.9463 -5.31761 6.83655 -25.2986 +569 2 16.721 16.066 14.8837 -6.35164 3.20497 21.4179 +570 2 17.8286 15.8261 13.9944 18.3936 -6.902 3.79502 +571 1 13.1598 0.895115 16.6829 -10.2787 13.0231 -1.21317 +572 2 14.0985 0.838925 16.8484 11.7714 -2.60716 3.82434 +573 2 12.9094 -0.0108285 16.49 -7.09766 -5.67505 2.02872 +574 1 10.9245 14.5193 7.39494 -10.4099 -10.8827 23.6465 +575 2 10.1209 14.2503 7.91799 23.546 5.98273 -19.3945 +576 2 11.6246 13.8906 7.65805 -5.45953 8.29317 -8.96944 +577 1 17.5666 8.45977 2.1077 -2.45541 -18.4017 -7.84499 +578 2 16.6916 8.4078 2.54921 14.2221 -0.924117 -8.74119 +579 2 17.6058 7.68446 1.4828 -2.53767 24.5137 15.8214 +580 1 12.3693 7.85876 1.99742 11.9287 1.39128 11.652 +581 2 11.9574 8.70597 1.81668 -2.84663 4.1279 -5.57453 +582 2 12.0661 7.22941 1.33154 -5.87406 3.00715 -1.1515 +583 1 12.0244 14.6632 10.3909 28.0505 -1.98221 6.53788 +584 2 12.2154 13.9026 9.84664 0.841551 -5.23881 -6.52272 +585 2 11.0973 14.8027 10.3697 -37.2752 0.615569 -5.61626 +586 1 6.83101 6.95959 15.54 -26.922 -25.3261 -7.84618 +587 2 7.74646 6.93869 15.3131 28.0025 5.72032 -4.23149 +588 2 6.70706 7.70294 16.1074 0.47288 18.1258 13.2198 +589 1 7.99181 4.56873 13.323 -17.7662 10.8645 -2.94772 +590 2 7.11502 4.75523 12.8947 23.3848 -2.11675 2.9311 +591 2 8.34221 5.42155 13.6369 -8.03699 -10.5621 -3.57795 +592 1 13.4097 12.1854 14.3195 -5.65215 6.28756 1.83858 +593 2 13.0403 11.2921 14.2436 5.24433 -3.00833 -1.58816 +594 2 13.8498 12.3732 13.4771 -2.55607 -2.02901 -2.35573 +595 1 14.6454 9.43305 7.28195 10.7596 15.6461 6.41649 +596 2 15.5174 9.89596 7.36949 -20.7431 -7.51972 6.68313 +597 2 14.0059 9.84843 7.89782 12.5114 -5.65293 -10.9965 +598 1 12.693 16.9181 3.21868 4.13721 -47.3842 -7.97708 +599 2 12.7878 17.338 4.04875 4.47204 15.8163 32.4195 +600 2 12.4838 17.5994 2.61833 -10.0532 31.8516 -27.8744 +601 1 1.00841 7.13021 17.3596 12.9632 -6.47488 11.204 +602 2 0.140567 7.22584 17.7618 -2.41623 -7.13214 2.78808 +603 2 0.956632 7.61621 16.5408 -0.0488819 7.87685 -11.8994 +604 1 12.917 4.94058 15.6965 -33.9833 6.00302 -1.61153 +605 2 13.6432 4.4005 15.9475 28.608 -13.7192 2.54357 +606 2 13.1955 5.85458 15.7909 9.71851 9.87704 0.635703 +607 1 2.3887 3.3689 5.15584 14.955 -15.9692 -52.0278 +608 2 1.80093 3.08916 5.81858 -25.593 -10.9876 33.4797 +609 2 2.79381 4.15677 5.46164 14.8077 31.4017 13.6729 +610 1 8.27435 11.0395 13.6153 -37.0795 23.6732 -65.6931 +611 2 8.36475 10.9269 14.5167 14.9976 -12.7369 63.1872 +612 2 9.08207 10.7919 13.1709 13.5323 -11.5041 2.55762 +613 1 12.9711 1.50053 13.2758 -7.16838 -21.0368 21.1096 +614 2 13.525 1.50324 12.5105 16.6349 2.94139 -20.1138 +615 2 12.6114 2.3778 13.3258 -6.20414 13.0805 -2.33086 +616 1 6.55993 13.5741 2.17335 4.5265 3.63418 -23.4358 +617 2 5.93511 13.8533 2.83279 -12.7543 7.85744 13.7798 +618 2 7.20659 13.0527 2.65116 1.25385 -4.10852 0.808212 +619 1 15.8831 6.47501 12.6409 22.0814 4.72601 -0.603906 +620 2 16.4738 6.98335 12.028 -14.2245 -11.2946 14.6347 +621 2 16.3705 6.43226 13.5009 -10.5632 5.96191 -15.5708 +622 1 16.8031 0.705923 9.56407 -2.28595 11.5891 -8.26827 +623 2 16.6552 18.4511 9.84906 2.3526 -17.7501 5.98934 +624 2 16.3731 0.773302 8.69375 1.62838 3.03603 0.698224 +625 1 6.10625 11.6157 8.28914 -3.08711 55.9701 7.34602 +626 2 5.36711 11.2964 8.79127 -16.3164 -7.54559 6.80515 +627 2 6.5283 10.8686 7.94164 19.8706 -42.6353 -12.8098 +628 1 2.81358 8.70539 0.376179 36.8039 -5.08598 16.3747 +629 2 2.33554 8.23944 18.3571 -22.6922 -9.90678 -17.9478 +630 2 2.28148 9.42572 0.700092 -14.5476 7.98537 3.82577 +631 1 10.114 10.4289 6.56839 -5.48816 -6.21666 7.2072 +632 2 10.5648 9.70982 7.03635 1.99723 -0.0329781 -1.13968 +633 2 10.3487 10.347 5.64237 7.8387 0.67993 -6.97128 +634 1 6.81211 15.7679 6.65103 -0.348958 5.58939 -1.23617 +635 2 7.12762 16.1335 7.48534 -0.336507 -3.46393 3.99871 +636 2 7.12562 16.4168 5.9986 -1.75978 -6.48118 -4.29666 +637 1 6.49059 12.9347 5.74014 0.722488 11.3509 6.39713 +638 2 6.52544 13.8593 6.05125 4.61742 -7.45139 -3.43251 +639 2 6.13117 12.4341 6.48422 -0.637044 1.07223 -0.836688 +640 1 16.7722 12.5296 9.75372 -10.3378 8.80589 22.9139 +641 2 16.9709 11.8837 9.07779 5.41942 -3.21474 -11.15 +642 2 17.3199 13.309 9.62307 0.866334 -2.28521 -6.10033 +643 1 6.18734 2.89369 2.76381 6.70118 21.5641 -20.0406 +644 2 6.53969 3.77128 2.46465 -8.05809 -16.0544 14.4298 +645 2 5.6766 2.59589 1.99155 1.09601 -8.68373 7.94101 +646 1 10.8178 3.09588 3.24672 1.33393 -8.05069 0.148042 +647 2 10.2056 3.80475 3.46561 0.323029 3.07521 -1.63087 +648 2 10.3998 2.55919 2.55618 -0.935454 8.00813 2.52947 +ITEM: TIMESTEP +70 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.83052 6.78564 17.8747 4.81039 14.7119 7.93216 +2 2 8.02044 7.08583 18.306 -2.95347 -6.04078 -1.17349 +3 2 8.57794 6.09723 17.2713 -4.49598 -11.7014 -7.63976 +4 1 0.124161 8.31212 6.74558 -2.09679 -1.27724 -21.4903 +5 2 0.320991 8.02726 5.80661 -3.30063 7.0305 29.7013 +6 2 0.593986 7.72695 7.35611 1.84479 -1.64007 -4.64643 +7 1 8.55341 0.214487 6.89794 4.20955 -4.60902 11.3327 +8 2 9.45965 0.255338 6.58274 3.95615 -0.229119 -0.443755 +9 2 8.09377 0.850204 6.35793 -6.3823 8.35705 -5.64785 +10 1 6.52177 1.69631 11.7106 -29.0447 -4.52087 -3.66773 +11 2 5.85029 2.25877 12.1616 13.2184 -10.2105 -7.98022 +12 2 6.00884 0.936302 11.3174 15.6542 21.0994 14.986 +13 1 6.92822 5.5902 2.37948 23.4336 -17.8876 -5.1013 +14 2 6.5261 5.8779 3.18071 -18.514 8.45901 19.042 +15 2 6.74676 6.28055 1.75003 -1.36947 6.04298 -15.8103 +16 1 16.1916 10.2374 16.1412 -24.0328 -6.0953 4.14694 +17 2 17.0138 10.497 15.7581 19.6671 8.99174 -7.62884 +18 2 15.6617 11.0456 16.2513 11.6446 -5.87426 0.419849 +19 1 10.7179 14.9528 2.30402 9.26606 5.76352 20.4147 +20 2 10.604 14.349 3.06349 2.85769 5.88214 -5.84145 +21 2 11.1755 15.7297 2.69585 -5.79349 -8.7688 -7.8832 +22 1 17.1683 8.21322 10.7989 1.82063 -1.23871 -1.95171 +23 2 16.5117 8.80699 11.1832 -0.385781 3.51193 7.00123 +24 2 17.9642 8.75858 10.6912 0.976865 0.382705 -5.65698 +25 1 14.6466 15.9322 16.4418 -21.6809 -6.01765 9.50279 +26 2 13.7097 16.2329 16.4085 18.6708 -4.64396 -3.84163 +27 2 14.6751 15.3815 17.2568 4.92661 10.5457 -14.6576 +28 1 12.1005 13.348 0.567693 14.0677 -11.0124 3.49805 +29 2 11.7977 13.4785 18.3054 -3.25303 6.53047 -2.60123 +30 2 11.7369 14.0166 1.16546 -7.92056 -0.136763 -7.41856 +31 1 9.34615 5.48792 3.88275 21.7787 0.248377 2.40385 +32 2 8.84331 5.37966 4.67443 -9.14 -4.08483 27.4632 +33 2 8.65688 5.52523 3.23949 -14.702 1.76912 -26.3373 +34 1 1.6606 4.00652 11.6035 4.04251 -10.384 -6.17332 +35 2 1.67583 4.94617 11.8049 -2.44143 11.0832 5.72027 +36 2 2.2695 3.55993 12.2146 -3.92557 1.72629 -0.38872 +37 1 2.08139 6.85853 8.20375 5.25116 9.81515 7.60897 +38 2 2.56831 7.24635 8.96213 -7.90159 -5.93168 -10.5698 +39 2 2.00199 5.91426 8.39105 -0.650687 0.0621593 5.33933 +40 1 5.36768 4.45674 7.91405 -3.32795 5.87339 3.17518 +41 2 5.46396 3.51228 8.0104 5.66802 -14.4695 -1.12836 +42 2 4.78412 4.56623 7.16078 -4.98903 9.02084 -4.56071 +43 1 3.31193 2.91026 17.4243 5.25503 -22.5991 -0.535021 +44 2 3.97925 3.43469 16.9765 8.2555 0.833912 -8.18173 +45 2 2.82292 3.51814 17.9594 -9.74498 21.4045 11.9966 +46 1 7.44628 5.47686 6.16962 4.83779 4.18627 -38.8589 +47 2 7.80337 6.02378 6.84422 19.7966 19.2933 17.1246 +48 2 7.08839 4.74785 6.63594 -15.5951 -22.4752 14.0992 +49 1 9.79841 6.99298 12.0115 -14.4173 0.175621 -19.7413 +50 2 10.2338 6.25953 11.5352 -7.27244 10.6531 4.67439 +51 2 9.07403 7.33711 11.4082 20.5779 -11.7539 16.8314 +52 1 14.0932 3.73018 8.11294 -2.35225 21.206 2.79521 +53 2 13.7164 4.53948 7.70027 6.06412 -15.1972 7.35067 +54 2 14.2932 3.96864 9.04107 -1.96145 -2.4542 -11.4015 +55 1 4.4865 17.2305 3.91995 2.87421 -17.2964 21.8602 +56 2 5.37817 17.5632 3.85852 13.1015 6.2627 -4.15101 +57 2 4.01126 17.4425 3.12603 -6.70645 13.3364 -16.7923 +58 1 16.3503 16.556 10.4027 -28.8153 -10.9362 -6.11544 +59 2 15.5262 16.5238 10.94 14.5825 4.08322 -8.19499 +60 2 16.0782 16.1167 9.56389 6.69544 5.4961 14.7824 +61 1 2.00781 4.81695 0.19428 -16.7794 -3.94444 -13.379 +62 2 2.36068 5.21925 0.976813 15.1603 4.4174 16.1734 +63 2 1.77343 5.5764 18.2905 0.379182 1.41768 -5.2961 +64 1 11.3582 13.2716 16.3898 -3.93488 16.8957 9.12151 +65 2 10.9039 12.4355 16.5285 -2.10099 -6.82713 -1.65452 +66 2 11.9323 13.1324 15.638 7.04428 -4.38588 -8.74921 +67 1 10.1365 10.938 16.8467 -2.82235 24.3376 4.32555 +68 2 10.5718 10.0987 16.7812 6.05632 -17.4389 0.305733 +69 2 9.20542 10.7786 16.7086 -10.6888 -4.42603 -1.21793 +70 1 11.8139 17.4685 13.4625 16.8497 6.47801 1.45884 +71 2 12.3399 16.8066 12.9857 -2.09189 7.12722 0.625626 +72 2 12.305 18.316 13.3535 -13.8327 -6.90215 0.736174 +73 1 6.44924 9.38958 12.2401 6.69888 0.367183 -15.9058 +74 2 7.02028 9.14259 11.4734 -10.412 6.11649 20.9521 +75 2 7.00474 9.9221 12.8226 3.16796 0.0903621 -0.913647 +76 1 16.2861 12.8631 2.69282 -5.5095 27.1919 6.93721 +77 2 17.1297 13.3403 2.5399 -11.4064 -12.6315 1.20497 +78 2 15.6248 13.5969 2.82884 15.7371 -22.5818 -6.03687 +79 1 0.705842 12.6958 5.89372 11.1118 0.602373 24.8353 +80 2 1.18521 12.4959 5.09265 -4.47491 1.87676 -19.0631 +81 2 18.418 12.5564 5.72922 -11.8137 -1.703 -8.70405 +82 1 5.28198 16.3804 18.4185 -2.246 1.3069 9.83982 +83 2 5.62966 15.5825 18.0261 2.19299 -6.30074 -9.03385 +84 2 5.78103 16.4802 0.590407 -0.738213 6.24336 1.72583 +85 1 0.669378 7.71651 4.13384 -59.2278 -40.1014 26.2385 +86 2 0.0696389 8.03317 3.4616 -5.2936 5.59306 -12.1338 +87 2 1.48105 8.07531 3.93226 66.8664 27.2164 -22.0097 +88 1 3.17848 8.98449 6.48797 -11.6429 31.0556 -28.5774 +89 2 3.69754 8.52221 7.10624 17.5545 -20.4274 28.0681 +90 2 2.28321 9.06095 6.81713 -8.12873 -6.01142 5.66961 +91 1 7.27057 10.3561 16.259 12.8547 -0.986094 -7.05958 +92 2 6.52139 10.8488 15.9387 -6.88577 4.52419 -2.25862 +93 2 7.07809 10.1849 17.1799 -5.89204 -3.21212 7.89434 +94 1 11.0493 0.926342 5.00492 7.6282 -0.312775 10.2028 +95 2 11.2745 1.78939 4.63491 -8.49938 0.0964505 -4.50291 +96 2 10.791 0.378052 4.25157 -0.730025 2.38059 -0.222793 +97 1 4.31171 2.85627 13.1955 -2.92819 26.6809 -11.7177 +98 2 4.37585 3.38692 13.9969 4.42074 -3.40265 4.05123 +99 2 4.21422 1.95476 13.4751 -3.58996 -22.8444 6.9477 +100 1 8.4068 10.257 1.78795 4.04191 -13.9705 -5.37842 +101 2 8.26785 10.8775 2.49552 -4.14797 15.7472 11.4003 +102 2 8.5529 9.42866 2.25521 3.43453 -4.46737 -1.06154 +103 1 10.2803 1.70096 15.4762 8.76071 -4.61575 -1.32446 +104 2 11.1657 1.41822 15.7142 3.10462 2.167 2.36838 +105 2 10.3075 1.82832 14.5156 -8.33356 3.27592 2.91474 +106 1 2.63173 12.8085 7.89063 4.0959 -9.21484 -0.859497 +107 2 3.2295 13.3973 7.41028 -2.49756 4.22571 1.84267 +108 2 1.98308 12.5062 7.24287 -1.99659 4.67741 -0.497136 +109 1 3.82895 11.7184 5.01628 -2.65331 8.28036 11.6201 +110 2 3.66291 11.1157 5.74556 0.426771 -3.98214 -1.1075 +111 2 3.01542 11.7805 4.50368 -0.128738 -0.0731644 -2.81963 +112 1 6.76514 14.4734 16.965 3.61018 3.02569 -11.8589 +113 2 7.44445 15.1431 17.0872 4.2046 -3.50831 2.36163 +114 2 6.5725 14.4959 16.0119 -5.95898 4.08629 6.49151 +115 1 14.2172 14.5156 3.23512 -15.7654 4.80027 20.0484 +116 2 13.9157 15.4376 3.23841 -0.320177 -6.15912 -4.56224 +117 2 13.7912 14.1249 4.0321 9.04818 0.126488 -15.8424 +118 1 8.62194 18.1001 16.0659 -23.21 2.71751 -2.03066 +119 2 9.16623 17.3958 16.3546 8.59431 -35.107 8.94544 +120 2 9.24682 0.159724 16.0687 7.59352 33.2076 -10.3682 +121 1 4.64785 1.66473 4.88429 20.0976 -32.3539 12.8345 +122 2 3.91841 2.23972 4.98678 -27.2909 21.6553 1.42112 +123 2 5.29938 2.12424 4.3745 8.75708 11.4615 -15.3566 +124 1 14.996 12.6195 16.4803 11.4842 8.30008 2.93566 +125 2 14.5677 12.8295 17.3315 -5.03395 -0.949445 -14.8823 +126 2 14.3989 12.5973 15.7101 -8.95177 1.91572 10.2236 +127 1 15.728 18.434 16.8656 -21.8007 21.3443 -35.9839 +128 2 16.2692 18.4514 17.6234 28.2096 -0.560819 33.2727 +129 2 15.2446 17.617 16.9069 0.184765 -20.6285 -2.2654 +130 1 1.36479 1.27889 16.6468 -16.7944 -10.044 -5.49533 +131 2 2.14801 1.79564 16.8219 8.14362 6.44014 2.70449 +132 2 0.693336 1.65446 17.2331 2.17778 -0.49248 0.882874 +133 1 18.205 4.38071 15.9717 -12.5383 1.08179 -4.34425 +134 2 17.9247 3.87865 15.1967 2.33887 0.121173 2.56773 +135 2 0.514445 4.3883 15.9876 8.17504 0.178033 -1.34417 +136 1 12.1632 17.0104 16.1415 17.8243 8.47052 -8.26904 +137 2 11.4339 16.4838 16.4748 -11.8796 -0.396392 0.7857 +138 2 12.1013 17.0682 15.1696 -12.6199 -2.93135 7.53111 +139 1 16.1201 2.6287 18.1864 3.80406 -3.99791 19.9987 +140 2 15.7935 3.50022 18.4009 -8.69312 10.1277 7.25942 +141 2 15.8264 2.47036 17.3057 -5.74882 -3.05042 -27.5508 +142 1 6.63908 13.8237 10.1059 1.54133 -19.2408 -0.896874 +143 2 6.60488 13.4547 10.9999 -2.4531 4.12781 1.41157 +144 2 6.6237 13.027 9.53669 -1.978 12.9815 -0.0933135 +145 1 10.1367 18.5192 2.71126 14.9692 1.08893 5.4249 +146 2 10.5375 0.290475 1.93143 -3.72697 -2.23961 5.76435 +147 2 9.31873 18.1319 2.42821 -14.2623 -5.70844 -7.57952 +148 1 3.05388 17.7183 6.14163 -17.3097 -9.85118 -22.5426 +149 2 2.24205 17.5791 5.58071 14.4512 3.50974 23.581 +150 2 3.73807 17.7208 5.46344 2.0394 5.03095 2.09251 +151 1 12.6118 16.8054 7.95495 4.58219 1.15158 -10.9791 +152 2 11.8555 16.2225 7.90842 -7.26482 -13.9478 -6.78863 +153 2 12.3849 17.4156 8.64585 -0.135632 15.5831 16.1371 +154 1 14.8975 15.2817 8.22586 -10.0433 25.2404 1.15436 +155 2 14.1016 15.8482 8.35876 13.2826 -12.9576 -5.35538 +156 2 15.2902 15.6258 7.39629 -1.79461 -13.1873 12.9757 +157 1 17.8242 18.245 0.290753 35.0262 5.69882 -22.3559 +158 2 18.562 17.7688 18.4584 -26.5201 3.44978 21.3008 +159 2 18.2553 0.461923 0.458274 -15.0979 -6.94564 5.00195 +160 1 0.811942 10.4929 1.40956 8.77271 16.3938 -17.0751 +161 2 0.0922351 9.87336 1.50209 -12.9574 -8.99075 8.33498 +162 2 0.506251 11.1761 0.770938 6.09002 -9.92994 11.4815 +163 1 1.80057 12.2567 3.3157 -0.00821892 -5.58838 -28.0373 +164 2 1.51905 11.5718 2.65287 2.57103 10.7079 19.8708 +165 2 2.13035 12.9839 2.7472 -5.7627 -4.92842 11.1942 +166 1 0.668516 17.2609 4.94683 -35.85 3.98858 25.1078 +167 2 0.0697466 18.0029 5.19004 17.5579 -5.46754 -17.9658 +168 2 0.309089 16.5456 5.51301 20.6369 3.3795 -13.3957 +169 1 1.1258 0.902495 9.33726 -12.4564 -3.06084 39.8122 +170 2 1.2842 0.722879 10.3134 -2.51149 4.27857 -26.5162 +171 2 0.280567 0.461704 9.18062 1.78742 1.97705 -4.09399 +172 1 16.751 2.38387 13.3212 3.93571 18.018 2.1702 +173 2 16.8889 2.64612 12.3995 3.13812 2.89192 3.07637 +174 2 16.5572 1.45381 13.2916 -4.67688 -18.3777 2.25645 +175 1 2.721 15.8932 12.0356 -10.4038 6.64935 25.1991 +176 2 2.99704 15.5189 12.8835 -2.56405 3.43208 -4.36032 +177 2 3.3254 15.553 11.3859 5.26998 -2.53603 -11.8474 +178 1 16.4132 15.6174 6.13158 -30.6236 -31.2218 7.18947 +179 2 17.2889 15.5331 6.46785 25.936 1.45578 4.51193 +180 2 16.388 16.3213 5.51027 2.55474 24.6255 -21.834 +181 1 5.75165 5.17156 11.8076 -10.0158 20.8309 8.83951 +182 2 5.58328 6.03799 12.2608 0.394348 -20.1746 -10.5178 +183 2 4.95414 4.6515 11.9927 8.5068 -2.87995 -2.26002 +184 1 15.1308 4.87532 0.804768 27.2949 -1.75024 -19.8676 +185 2 14.8777 4.72649 1.70618 -7.53991 -8.08598 20.9925 +186 2 14.4372 5.36761 0.397065 -18.333 11.5318 -5.57633 +187 1 16.3608 16.424 1.96087 0.545069 28.5814 -7.81874 +188 2 15.9402 16.8572 2.72963 9.40909 -7.94755 -2.88814 +189 2 16.7928 17.1706 1.4719 -7.75465 -17.4072 6.82817 +190 1 0.195497 4.8427 3.9016 -20.8114 -16.3238 -7.36148 +191 2 0.347935 5.77048 3.88737 2.90582 31.823 0.953261 +192 2 1.01225 4.48793 4.21241 18.9183 -15.2676 9.08502 +193 1 2.99687 15.0761 15.1729 -7.80035 25.004 -19.9303 +194 2 2.75027 14.6107 15.9518 -1.28992 -16.7566 29.7079 +195 2 2.55205 15.9391 15.3182 6.19364 -5.6546 -9.94962 +196 1 1.13925 14.6508 9.53021 19.9076 23.5081 3.98588 +197 2 2.07639 14.8825 9.77663 -29.323 -13.131 -7.88186 +198 2 1.04812 13.6993 9.55892 5.54263 -6.82879 4.76298 +199 1 13.5171 16.5199 11.5195 20.4201 8.76324 22.1576 +200 2 12.9867 17.257 11.2155 -0.855064 7.64635 -14.0191 +201 2 13.0442 15.7467 11.2378 -7.08331 -12.4379 -10.7884 +202 1 4.66723 1.48136 0.73322 23.0149 3.26353 10.1864 +203 2 3.99044 1.945 0.247475 -7.51763 5.99594 -9.81004 +204 2 4.21698 0.879204 1.33273 -6.6714 -6.19828 -5.18082 +205 1 1.48126 18.5865 11.8932 5.77456 11.9109 13.6761 +206 2 1.45047 0.509997 12.7065 -0.655319 -12.4833 -18.3988 +207 2 2.16842 17.9125 12.0331 -8.54366 2.69761 2.01722 +208 1 11.4638 10.1444 4.04596 -29.9846 -9.43843 22.7531 +209 2 11.586 10.5695 3.21678 -1.49335 12.1472 -28.3165 +210 2 12.3366 9.99459 4.35585 30.6386 -4.62302 8.08877 +211 1 8.15809 12.1698 3.75544 16.5318 -12.8496 -25.3624 +212 2 9.0168 12.5594 3.97136 -0.0903232 2.9732 11.2136 +213 2 7.55758 12.2779 4.48666 -4.55936 7.15494 21.2951 +214 1 14.57 4.03338 3.33424 -15.9396 -3.34089 -13.9779 +215 2 15.2475 4.30951 3.93522 14.2067 0.133456 17.245 +216 2 13.7488 4.35662 3.71839 -4.37522 2.77806 -1.52286 +217 1 5.69573 1.64484 7.55416 47.4861 32.5669 -28.9041 +218 2 5.02314 1.22164 8.01158 -49.1519 -34.4826 29.3881 +219 2 5.51675 1.48645 6.61188 -4.44278 2.0561 3.75596 +220 1 17.8757 1.08291 4.8338 -2.11434 0.172647 4.71576 +221 2 18.4455 1.46692 4.16357 3.67184 -2.89676 -9.33974 +222 2 18.0165 1.6381 5.60499 -0.396504 -0.0112538 6.48923 +223 1 6.85338 9.35555 4.52322 8.01303 -7.73923 12.5712 +224 2 6.71294 9.49068 5.48294 3.02765 -1.76203 -13.5451 +225 2 7.79052 9.06961 4.44068 -13.079 3.18293 -1.46589 +226 1 2.62197 14.8521 2.02937 -10.5221 3.39156 -23.0918 +227 2 3.43005 14.7674 2.51892 12.1264 -2.78802 16.39 +228 2 2.89555 15.1253 1.13827 -2.73698 -5.91865 10.4405 +229 1 17.3299 12.9421 13.1931 -12.7738 17.025 -7.03447 +230 2 16.4383 13.2606 13.4479 14.3464 -2.45707 -5.73497 +231 2 17.7945 13.7546 12.8897 -6.22536 -14.4165 5.27249 +232 1 14.8979 10.5619 1.48982 -11.9525 28.8063 14.5441 +233 2 15.3485 11.4081 1.81139 -13.0513 -30.8314 -8.90843 +234 2 13.9324 10.6539 1.67123 25.3412 1.8999 -4.23485 +235 1 5.67595 6.67872 4.55433 0.362155 18.5292 -10.9955 +236 2 5.7867 7.61135 4.29326 0.453279 -5.37291 7.09585 +237 2 6.40948 6.48302 5.14674 -0.086512 -6.41659 5.49044 +238 1 7.99316 8.32936 10.3099 -9.88556 -13.348 -36.673 +239 2 8.52429 8.77949 9.6279 3.30308 5.35046 16.0689 +240 2 7.32365 7.86355 9.75728 7.50693 2.48224 14.219 +241 1 13.4328 18.4778 5.70681 16.0844 -0.193399 -6.38488 +242 2 12.6986 0.421386 5.55211 -13.5651 7.65576 -7.58054 +243 2 13.084 17.8957 6.37412 -0.0453673 -15.2248 15.7361 +244 1 -0.0111344 2.60704 0.305045 25.2129 -30.2702 8.72131 +245 2 17.7164 2.72495 0.164021 -32.2143 -6.6311 -9.93678 +246 2 0.303096 3.48034 0.225751 24.1306 33.5707 -2.06333 +247 1 12.8325 10.9421 9.75806 8.08682 -36.6012 3.93532 +248 2 11.88 10.8422 9.79419 -10.8426 11.3849 -4.95145 +249 2 13.0795 10.0004 9.94273 0.259667 22.5692 -5.0531 +250 1 0.642026 12.1683 11.0609 4.45464 6.09796 -5.6804 +251 2 18.3356 12.2213 11.2584 6.06715 1.14224 4.76964 +252 2 1.15053 12.4132 11.8471 -8.72956 3.82018 2.8882 +253 1 5.19121 7.35128 13.362 14.2217 -1.26987 2.88721 +254 2 5.71731 8.09811 12.9969 -6.96977 -10.5111 6.72344 +255 2 5.67215 7.04852 14.1611 -4.50302 8.90065 -9.08298 +256 1 1.17753 6.82665 11.884 -6.96202 23.1207 3.27017 +257 2 0.332868 7.13942 11.4836 19.3553 -6.8941 9.30012 +258 2 1.59694 7.61812 12.3119 -7.65201 -17.5731 -13.8958 +259 1 15.4801 9.74186 12.3501 8.02403 -36.537 -7.5848 +260 2 15.2771 10.6331 12.1319 -8.61126 25.0623 0.312061 +261 2 15.6595 9.70704 13.2832 1.37326 2.5629 11.9963 +262 1 16.5169 12.594 5.50965 10.4637 -15.548 10.5874 +263 2 16.3074 13.4879 5.77305 -4.76715 16.3332 -4.64473 +264 2 16.4013 12.5274 4.55501 -3.26126 3.70708 -8.86796 +265 1 6.31292 9.82321 0.0853393 -0.254663 19.8779 15.0366 +266 2 5.47299 10.2624 0.316114 7.63969 -1.93852 0.671735 +267 2 6.95815 10.0698 0.784254 -6.58085 -1.04763 -9.09577 +268 1 12.2316 6.09819 4.0135 -11.5327 11.7492 -3.18772 +269 2 12.1819 6.93481 3.49894 6.0574 -18.2652 4.97925 +270 2 11.3139 5.7855 4.02535 4.75129 -2.10791 -0.415098 +271 1 0.346102 12.8439 0.0895734 -4.86896 0.353582 5.39062 +272 2 18.7507 13.4631 0.799834 -0.48412 -1.67542 -1.66039 +273 2 18.3682 13.0274 18.0218 -2.69393 2.08889 -5.2677 +274 1 3.5489 0.022651 8.64264 14.8213 -2.21723 6.15117 +275 2 3.34146 18.2537 7.79412 -1.37888 1.54429 -1.85278 +276 2 2.69807 0.312924 8.99074 2.91061 0.134312 -8.36673 +277 1 7.48275 17.4677 4.49597 -9.82961 -11.4008 2.47905 +278 2 7.76172 18.3639 4.65831 -0.473756 11.2371 0.709742 +279 2 7.61951 17.3416 3.55584 -1.72206 -2.44101 -5.98946 +280 1 9.27482 17.1419 12.2002 -29.9673 17.8198 -3.75997 +281 2 9.29449 16.2474 11.8858 2.76409 -17.0257 -9.00951 +282 2 9.96887 17.232 12.8306 24.004 1.27191 14.3563 +283 1 13.3881 13.0638 7.94543 23.8544 1.05207 16.0454 +284 2 13.4911 12.3591 8.61055 -7.80977 1.42534 -8.25381 +285 2 14.1677 13.6583 8.10929 -22.3675 -6.64423 -7.05202 +286 1 14.8196 2.98416 15.4059 10.9247 4.82989 11.3692 +287 2 14.1977 2.30622 15.182 -14.8004 -11.8419 -2.86461 +288 2 15.3715 3.04555 14.6288 11.3419 0.403673 -8.50968 +289 1 9.89007 15.644 16.9507 -0.476448 -13.1737 2.9886 +290 2 10.2689 14.811 16.6236 0.33136 1.14394 -2.50282 +291 2 9.50974 15.3862 17.8064 -0.51987 6.75584 -0.702029 +292 1 11.2404 8.49746 16.6126 -11.0388 -24.1902 -5.6141 +293 2 10.5493 7.95233 16.1656 11.7734 11.5748 6.95591 +294 2 11.5411 7.95338 17.3605 -0.459906 4.27214 -6.12679 +295 1 3.94653 18.1828 16.8275 -12.5536 19.575 -10.0724 +296 2 4.49583 17.6028 17.3635 4.26127 2.6886 8.36922 +297 2 3.95977 0.456308 17.1729 5.72776 -19.9128 0.46306 +298 1 2.2132 4.22212 8.91052 -3.52394 3.62108 -17.0138 +299 2 3.14576 4.09878 8.74947 8.67559 -2.34434 0.767855 +300 2 2.06536 4.03466 9.83165 -0.817379 -1.75645 17.2153 +301 1 9.87247 10.3712 9.74928 14.7683 -30.296 -5.49075 +302 2 9.62147 11.2221 9.45607 -13.6864 32.2476 -14.4563 +303 2 9.99394 10.4206 10.6874 0.365841 -1.43755 21.5864 +304 1 9.68376 0.92477 10.8522 -9.86416 -7.8375 -9.37303 +305 2 9.18791 0.169256 11.2055 11.1043 -0.796798 3.35444 +306 2 9.09399 1.23638 10.1435 10.2069 6.90097 4.69651 +307 1 9.16769 15.091 10.1956 22.4355 7.87639 6.21774 +308 2 8.9696 15.9691 9.88131 -3.17938 11.9605 -8.33522 +309 2 8.32743 14.6622 10.1389 -19.5916 -16.662 -1.08184 +310 1 0.85922 9.69743 10.2442 32.6336 -47.5631 -25.4673 +311 2 1.02374 10.6105 10.3992 -2.53948 25.7241 9.50189 +312 2 1.72313 9.35148 9.87448 -35.4256 9.68482 16.6576 +313 1 17.0256 4.81986 8.08308 31.6348 -31.2729 -9.48192 +314 2 16.3215 5.37214 8.33224 -31.3655 27.4802 10.3117 +315 2 16.9319 4.0155 8.6004 0.768816 2.34372 -1.45333 +316 1 14.8081 14.6794 0.153243 -2.85725 -11.5952 -11.9613 +317 2 15.2092 15.2804 0.771003 11.383 9.73034 15.7651 +318 2 14.0408 14.3115 0.591288 -7.92269 -3.99881 6.06231 +319 1 3.80416 11.0019 9.56526 0.623941 6.68377 2.11405 +320 2 3.77619 11.4642 10.4186 -0.043788 -6.16761 3.62327 +321 2 3.31763 11.5705 8.95624 -4.54045 6.84371 -3.4313 +322 1 11.3158 10.7476 1.45776 10.9951 -9.43983 2.74041 +323 2 11.5252 11.5694 1.01773 6.8042 14.5185 -3.76913 +324 2 10.3718 10.6573 1.35733 -14.9091 -3.38451 -2.45366 +325 1 13.1832 7.19978 12.6897 5.92706 -14.8401 5.32281 +326 2 14.1145 6.87754 12.7085 -13.0936 9.37511 -3.26372 +327 2 12.6462 6.38983 12.7968 5.91866 7.22274 -2.53959 +328 1 9.61767 1.88189 0.936979 -6.6056 8.12678 -33.3335 +329 2 8.75647 1.76915 0.468433 15.5153 -2.73343 13.4493 +330 2 10.2273 2.17983 0.230861 -6.38326 -0.489196 14.1696 +331 1 10.6523 13.47 4.56634 -17.7163 6.61907 -5.84307 +332 2 11.5562 13.1849 4.68206 11.5009 -9.86279 4.07703 +333 2 10.5151 14.0877 5.29021 -1.44258 0.681598 7.9468 +334 1 14.5213 1.69385 10.9785 0.412416 12.5139 1.3055 +335 2 15.3159 1.33414 10.5754 1.96072 -4.24727 -0.900333 +336 2 14.7412 2.63918 11.0728 -6.13642 -3.41388 -3.76294 +337 1 14.5042 12.0777 11.6111 -12.2061 0.510996 31.5423 +338 2 15.1827 12.4648 11.0978 29.2487 15.6657 -21.0239 +339 2 13.909 11.6953 10.9807 -16.843 -4.29027 -12.6849 +340 1 8.18401 5.11068 9.87002 -0.676892 -7.65738 -3.35075 +341 2 7.33939 5.06675 10.3357 0.521056 4.21206 1.1001 +342 2 8.29842 4.21721 9.50312 -0.00697362 5.6522 3.71152 +343 1 1.5768 16.9623 18.4443 13.7844 -6.06932 -11.1938 +344 2 2.08688 17.3314 17.6994 -1.29344 -1.55823 6.9248 +345 2 1.72478 16.0021 18.3853 -4.19272 5.84443 -4.03385 +346 1 1.47359 17.3466 15.3156 -41.3862 18.9515 21.4522 +347 2 1.38751 18.1942 15.8376 11.356 -22.4463 -17.1221 +348 2 0.531998 17.0202 15.2731 27.9598 4.08453 -2.72162 +349 1 3.56251 5.80266 6.06315 1.23781 -30.1986 0.952301 +350 2 2.9922 6.42371 6.50913 -3.22231 11.6367 6.59476 +351 2 4.22501 6.28135 5.5614 1.05528 7.23928 -6.44245 +352 1 12.5723 9.4951 14.2463 -14.1947 49.7353 4.36555 +353 2 12.9086 8.77822 13.7576 17.8642 -40.1771 -16.3075 +354 2 12.2963 9.16979 15.1004 -1.36164 -11.5003 11.0357 +355 1 4.07044 15.2648 6.99086 -8.22484 -15.5272 10.3185 +356 2 3.65725 16.0904 6.74002 -9.77102 8.77549 -2.61135 +357 2 5.00026 15.4315 6.88928 20.0063 2.47059 -3.54324 +358 1 0.744606 8.73408 15.0763 0.0218964 -5.95646 -3.10884 +359 2 0.519262 9.66197 15.1074 -7.84082 12.7234 2.89932 +360 2 1.47025 8.73132 14.4431 5.87969 -4.51966 -2.6491 +361 1 12.9306 8.27919 10.1905 8.08936 2.40022 19.7343 +362 2 13.779 7.90886 9.87037 -9.22858 -4.32337 9.26771 +363 2 12.8604 8.07471 11.1624 7.69549 -2.50096 -25.1681 +364 1 15.3235 7.85492 3.5497 18.4153 32.411 -54.1913 +365 2 14.4745 7.6657 3.15314 -16.0822 -13.4855 9.94503 +366 2 15.5116 7.64082 4.44166 -12.2255 -21.7424 34.152 +367 1 17.2256 6.71185 18.6385 13.0601 3.46678 -1.24204 +368 2 16.7837 5.9846 0.423329 -10.4159 -11.046 2.92977 +369 2 16.5307 7.32814 18.3852 -6.78357 2.8142 -3.2779 +370 1 8.8964 6.96848 7.83902 16.0931 16.0227 -2.80611 +371 2 9.83265 7.28699 7.8278 -17.1093 -4.77101 0.707558 +372 2 8.79691 6.46408 8.64714 -0.939429 -8.3316 9.69843 +373 1 12.4084 0.523138 1.23768 -2.06115 0.0733923 -7.11266 +374 2 13.1872 0.998726 1.54472 7.23891 -2.91784 -1.02165 +375 2 12.4662 0.537618 0.274809 1.69654 -3.93261 2.5223 +376 1 5.65468 15.0902 14.5334 3.02676 -25.5773 -0.125585 +377 2 4.72407 15.1616 14.7961 0.127409 2.72757 -0.91443 +378 2 5.99013 15.9712 14.3886 3.52657 16.2654 -6.40367 +379 1 3.82399 6.39797 1.75512 3.78691 -6.14258 3.26006 +380 2 3.37829 7.15763 1.38654 -6.41374 16.3556 -5.84968 +381 2 3.97609 6.61981 2.67876 -1.82166 -0.0414506 2.69272 +382 1 3.91801 11.4637 12.3808 6.26728 1.11409 -8.60855 +383 2 4.78798 11.8777 12.4982 -7.30712 -3.21292 -1.54071 +384 2 3.30212 12.087 12.775 -5.64928 0.778082 5.20377 +385 1 5.29676 3.85177 15.8189 3.43828 -31.27 -8.27082 +386 2 6.03967 3.23378 15.6029 -11.8461 12.1043 0.727598 +387 2 5.68429 4.70341 15.931 13.0054 23.274 1.41344 +388 1 14.2193 10.1559 4.56622 -21.9238 17.9967 10.7876 +389 2 14.2923 9.81422 5.45847 5.67938 -3.41822 10.3914 +390 2 14.6614 9.51741 4.03067 14.2685 -12.4061 -15.9356 +391 1 7.6994 17.3598 9.13069 2.58566 -7.07749 -1.38218 +392 2 6.9688 17.7373 9.6086 -11.208 -1.02501 12.7072 +393 2 7.91331 18.0249 8.47917 9.78731 5.09099 -13.1281 +394 1 4.50671 14.5226 3.97805 12.528 -25.4608 -46.8355 +395 2 4.48015 15.4086 4.24602 -0.161492 47.21 12.2969 +396 2 4.35306 14.022 4.74858 -6.07017 -24.5156 30.0525 +397 1 14.1411 7.46132 15.8217 -22.5264 -9.25347 -2.17647 +398 2 14.9826 7.35759 15.4044 20.5288 -0.540355 -7.58788 +399 2 14.3421 7.83921 16.6731 3.72262 6.08742 11.7763 +400 1 2.98184 18.372 1.90579 -20.1648 -30.237 -17.2141 +401 2 2.43548 17.7555 1.32026 19.5303 24.385 16.7936 +402 2 2.33791 0.236975 2.41065 -5.95562 0.980031 -0.0237849 +403 1 7.99445 1.58502 4.53075 18.7977 0.504684 -14.6733 +404 2 7.48712 1.99417 3.8192 -9.17378 0.780153 1.87786 +405 2 8.88078 1.50473 4.13387 -7.12077 1.17171 10.2984 +406 1 2.41951 14.1599 17.7056 22.0207 15.2121 -4.13121 +407 2 1.68443 13.6195 17.9516 -15.3327 -12.8663 8.26013 +408 2 3.18525 13.6986 18.0793 5.57496 -0.0710026 -2.65101 +409 1 0.908587 1.85846 13.8858 -0.0793858 -1.94323 14.6669 +410 2 1.14821 1.59902 14.7928 -3.46921 3.66635 -7.67361 +411 2 18.5942 2.00299 13.9058 4.01903 -0.250224 -6.72878 +412 1 4.32702 0.129386 13.8829 -0.0770511 3.08332 3.55447 +413 2 5.24833 18.5067 13.8286 4.90059 -4.64875 -2.30826 +414 2 4.05486 18.5232 14.7746 -2.81766 -1.27361 1.32354 +415 1 7.27357 0.854459 18.3804 -15.3869 4.3045 -1.1218 +416 2 7.16992 0.518993 17.4624 3.36336 5.55626 15.3605 +417 2 6.40185 1.20099 18.6914 11.5657 -10.6186 -10.5297 +418 1 15.9542 18.4046 13.9208 -25.3022 5.029 -14.7602 +419 2 15.0075 18.5254 13.735 13.8644 -2.42428 -4.09563 +420 2 16.0061 18.5076 14.8614 8.67486 -1.51607 21.0166 +421 1 10.2392 4.55204 16.2801 10.7238 -8.25817 -3.6178 +422 2 11.196 4.37813 16.4864 -24.802 4.89259 -9.76699 +423 2 9.86858 3.73489 15.891 10.2726 5.88423 10.0044 +424 1 15.9238 17.7149 4.45644 2.75189 -23.1215 -12.8271 +425 2 16.5168 18.4535 4.47728 14.6813 18.6917 2.39924 +426 2 15.0936 18.0469 4.76398 -21.0845 8.87368 10.3462 +427 1 6.95648 17.503 13.9077 -51.9825 -4.38955 -3.71365 +428 2 7.39002 17.773 14.6913 25.8751 9.72049 29.5532 +429 2 7.60747 17.4983 13.2335 27.2317 -2.92469 -23.3456 +430 1 13.2071 6.48879 6.54043 12.3601 -8.29587 -18.0485 +431 2 14.1818 6.5258 6.42811 -17.7974 6.95191 3.55269 +432 2 12.8555 6.35956 5.62691 5.37067 1.68412 18.5111 +433 1 7.86742 2.30794 9.39626 -5.35093 5.07188 8.74379 +434 2 7.30782 2.2926 10.1983 5.67726 -4.12754 -5.74363 +435 2 7.33716 1.92062 8.69482 -5.03183 0.0809058 -6.36949 +436 1 15.2078 14.7586 13.7432 0.832397 -4.30074 -2.87903 +437 2 14.8858 14.9257 14.6258 -3.94452 3.16733 11.6107 +438 2 14.9517 15.5204 13.2236 -2.78606 2.09491 -5.66724 +439 1 9.4202 8.34719 3.8485 -22.8652 4.71801 -4.87246 +440 2 10.1988 8.89706 3.87201 15.3465 4.97444 3.28263 +441 2 9.69606 7.44575 4.01411 1.53448 -7.03017 -1.02937 +442 1 17.7384 13.5884 16.4052 -11.7067 -11.536 8.32036 +443 2 16.7673 13.5542 16.377 3.38001 -6.87595 1.27552 +444 2 17.9496 14.385 15.9274 3.88108 14.0768 -7.71607 +445 1 4.90559 10.5521 2.87839 21.3367 -20.8737 -11.4011 +446 2 5.623 10.1254 3.38432 -4.07258 6.62764 -8.01418 +447 2 4.62886 11.2624 3.4373 -4.18877 12.0113 9.86562 +448 1 3.72998 8.3995 9.96949 0.206562 0.552242 5.18998 +449 2 3.80623 9.33185 9.71276 -0.050758 -4.34606 1.0469 +450 2 3.86748 8.41721 10.9275 -4.36654 -3.13592 -2.04235 +451 1 15.965 6.95365 5.95266 -6.26742 1.66997 1.55481 +452 2 16.7698 7.37181 6.25298 11.0034 6.69643 7.83926 +453 2 16.2161 6.06091 5.70554 3.02292 -8.38979 0.185448 +454 1 15.1879 7.19538 9.00463 -16.574 -33.0638 16.9279 +455 2 15.9728 7.55664 9.38717 21.7076 13.0833 8.35481 +456 2 14.9649 7.65827 8.21955 0.87619 20.3483 -26.3308 +457 1 6.20656 12.8742 12.7233 -2.45823 6.18764 -5.3718 +458 2 6.79799 12.2543 13.1384 18.4055 -9.75357 3.10315 +459 2 6.13621 13.6122 13.3363 -4.91508 8.57981 5.63651 +460 1 12.128 4.53555 13.1062 -17.5662 -8.78193 22.9206 +461 2 12.3906 4.63486 14.0411 2.44404 0.930561 -9.75427 +462 2 11.3004 4.01263 13.1714 14.0583 8.15169 -11.9376 +463 1 11.4184 8.10098 7.95437 7.14359 -3.91624 -16.2991 +464 2 12.1028 7.60478 7.4673 -7.16754 1.39876 -0.578178 +465 2 11.8093 8.18067 8.82553 -2.79742 2.89488 8.77133 +466 1 17.0514 10.8651 7.58728 -24.1088 0.784299 26.3012 +467 2 17.8144 10.3384 7.41217 20.5663 -15.9736 -11.9321 +468 2 16.8601 11.4269 6.84052 2.19633 6.48519 -17.1676 +469 1 5.231 18.0993 10.8546 26.455 4.8965 -4.82813 +470 2 4.8195 17.6908 11.6007 -11.7048 -9.88744 14.1218 +471 2 4.63699 18.0004 10.1206 -18.4061 3.17503 -16.8763 +472 1 7.59767 17.4436 1.69759 5.72815 6.19172 -16.2775 +473 2 7.89477 16.6568 1.18579 0.971667 15.0969 7.35096 +474 2 7.65141 18.2352 1.10536 -4.88626 -20.2664 5.47735 +475 1 1.93145 12.9234 13.6206 5.60545 -3.12143 -21.3855 +476 2 1.4749 12.3281 14.2061 -8.56587 -7.9862 10.2726 +477 2 2.17547 13.6903 14.1341 4.19375 11.0678 7.71152 +478 1 9.43748 6.79443 14.8327 33.0335 -30.4644 -7.71462 +479 2 9.91196 6.01751 15.25 -19.5648 18.6507 -3.60269 +480 2 9.7502 6.76156 13.9011 -9.65438 10.9618 10.9707 +481 1 15.2831 4.34212 10.7772 21.179 15.7439 -2.01388 +482 2 16.2293 4.27243 10.5111 -19.8675 -5.23 11.4528 +483 2 15.2971 5.09975 11.4021 -5.00612 -14.3562 -6.14057 +484 1 11.351 6.2072 0.109577 23.6613 28.7979 6.66193 +485 2 11.4872 5.27024 0.0694097 -6.21323 -21.6319 -6.22108 +486 2 10.4676 6.44004 18.4761 -18.3883 -9.25121 -2.88973 +487 1 18.5357 11.4228 14.9398 26.7643 -26.8403 31.1109 +488 2 18.0597 11.723 14.1947 -18.2778 17.0129 -29.9513 +489 2 18.4532 12.1424 15.5699 -5.23995 5.81903 4.32114 +490 1 7.05668 9.28071 7.31234 -6.58466 7.4517 -4.55549 +491 2 6.71011 8.47084 7.6978 -4.31789 -6.13087 1.68327 +492 2 7.98804 9.13135 7.18438 15.6823 -2.37616 0.276954 +493 1 18.324 15.3331 12.2569 -7.46978 -1.64803 5.36971 +494 2 0.564477 15.5946 11.9899 10.9599 1.36641 -5.51497 +495 2 17.7284 15.6281 11.5548 0.957946 6.58656 -2.69515 +496 1 16.4958 4.38611 5.25998 2.69003 14.057 -30.634 +497 2 16.6253 3.88668 6.0538 7.32023 -9.57738 16.711 +498 2 17.3371 4.41488 4.75201 -4.14044 -1.60108 11.4247 +499 1 17.7073 3.15256 10.779 -3.63642 -2.40486 -9.15002 +500 2 18.6235 3.40441 10.9111 8.43018 2.88916 7.88185 +501 2 17.7389 2.35032 10.2471 -2.89329 -5.91517 0.580451 +502 1 12.2813 18.6401 10.1181 2.89516 -35.5496 -8.35074 +503 2 11.4703 0.383955 10.4005 -29.8535 10.9583 6.97968 +504 2 12.9196 0.674429 10.2218 25.4798 25.6209 2.989 +505 1 10.3974 9.74216 12.5073 0.112101 -17.0368 -3.21727 +506 2 11.1947 9.82557 13.039 4.39701 4.68697 5.66162 +507 2 10.3035 8.76836 12.4158 -2.37231 15.8308 -1.56525 +508 1 0.663588 2.73535 7.12598 -12.3374 1.53361 -6.62113 +509 2 0.367817 3.62684 7.37457 5.09588 -7.68469 3.80292 +510 2 0.956045 2.28157 7.92852 1.53616 1.67998 2.79736 +511 1 0.311147 15.2759 6.88171 -13.4592 45.4783 4.03261 +512 2 0.500617 15.614 7.76495 4.81164 -9.60864 4.06796 +513 2 0.558697 14.3764 6.88071 13.8097 -37.6199 -4.57419 +514 1 17.0548 6.97395 15.0744 4.20776 -1.94343 -1.58424 +515 2 17.8177 7.57453 14.9855 -5.12063 -2.20736 -0.0554095 +516 2 17.4111 6.17613 15.4934 -0.113823 0.922547 0.618491 +517 1 9.1503 12.5213 8.01319 -14.1189 2.82879 0.278945 +518 2 9.53356 11.9725 7.3299 10.3093 -11.5802 -1.96405 +519 2 8.24075 12.6139 7.71394 -0.988228 2.45183 6.21614 +520 1 1.17609 1.70844 2.83295 3.23913 -2.31621 -1.89882 +521 2 1.09855 2.22978 2.02752 -9.74566 -1.77621 -3.35395 +522 2 1.86202 2.13223 3.34238 5.26299 8.17365 10.1548 +523 1 4.09291 15.1504 9.8922 18.1507 -7.2721 -6.40054 +524 2 4.03036 15.1629 8.92399 -1.00826 2.87435 -0.463193 +525 2 4.99389 14.8146 10.0732 -8.74469 0.915467 -5.31212 +526 1 7.37772 2.25117 14.7222 3.22505 8.21162 1.39777 +527 2 7.09502 1.54536 14.1374 1.57311 -0.181539 -4.41158 +528 2 7.85635 2.90205 14.1691 -14.4419 -9.06063 9.37489 +529 1 18.4006 14.5833 2.15968 -9.78242 8.50711 -1.4388 +530 2 0.62994 14.8842 2.46282 -4.8788 5.17113 -0.292034 +531 2 17.7517 15.3351 2.17575 17.725 -12.6913 0.414249 +532 1 9.99197 2.68277 12.9223 -2.58103 11.7713 -8.17336 +533 2 9.96789 2.1685 12.101 0.346485 -5.49174 3.23624 +534 2 9.29748 3.35451 12.7936 3.47695 -5.23648 4.96996 +535 1 2.96299 8.91941 13.096 19.2939 -0.203164 0.561242 +536 2 3.4486 9.7527 12.8428 -15.067 -18.0348 7.07188 +537 2 3.65865 8.27445 13.3679 -12.9331 14.6867 -6.35999 +538 1 3.26147 8.578 3.77304 6.38222 5.3653 -9.36202 +539 2 3.78874 9.26676 3.32736 -9.65467 -7.00498 -1.39723 +540 2 3.24393 8.8647 4.68594 3.08129 -4.64857 6.90262 +541 1 5.77287 7.24333 8.61048 -1.78661 -5.00814 9.07462 +542 2 5.68022 6.28289 8.53661 4.0016 -1.85755 -4.86386 +543 2 5.00276 7.50215 9.14094 4.61323 4.45406 -2.92895 +544 1 14.8793 1.52937 1.85035 -12.7334 -14.0835 12.9397 +545 2 14.819 2.16152 2.5876 10.8144 6.55959 -13.4181 +546 2 15.5594 1.73936 1.19754 -2.84827 11.2594 2.6977 +547 1 8.5607 15.0611 0.725284 0.46926 -2.1008 2.83341 +548 2 9.29259 14.9147 1.35885 -7.99161 6.01774 -7.32206 +549 2 7.81927 14.5289 1.05772 1.7687 -2.35649 0.826934 +550 1 15.4921 1.3993 7.20702 14.746 2.01238 2.95597 +551 2 14.8484 0.891915 6.72418 -10.4472 -9.96976 -7.88743 +552 2 15.1077 2.27361 7.28199 -8.00989 7.94424 8.07076 +553 1 5.01058 12.9585 18.4386 -15.8567 -4.4202 8.08993 +554 2 5.4193 13.0053 0.667327 2.46468 -0.195888 1.58163 +555 2 5.59523 13.4446 17.8643 8.60291 1.11734 -4.66644 +556 1 15.4019 8.61725 18.0949 -10.0539 -8.80276 13.7753 +557 2 15.8344 9.23888 17.5182 6.53635 7.63687 -15.5634 +558 2 15.1418 9.16559 0.203922 1.58583 0.47418 3.18719 +559 1 12.0525 3.11208 18.2861 7.73999 -14.4321 9.61497 +560 2 12.4007 2.82569 0.495607 -5.57788 10.1171 1.38067 +561 2 12.4066 2.43321 17.7002 -1.56388 4.26076 -9.69121 +562 1 13.1688 12.6857 5.1494 7.31226 -7.20074 3.10637 +563 2 13.4985 11.8462 4.78426 1.65488 6.62932 1.41885 +564 2 13.3525 12.6203 6.1046 -3.90991 6.43934 -4.24709 +565 1 6.08926 7.21668 0.130178 -1.88627 11.2856 16.2629 +566 2 6.12641 8.19603 18.8427 -2.9512 -23.7133 -6.32338 +567 2 5.32645 6.95656 0.679872 3.54107 -2.60359 -10.7249 +568 1 17.6547 15.8703 14.9132 16.2429 2.82715 17.6162 +569 2 16.6953 15.9075 15.0555 4.78919 3.7515 -14.6122 +570 2 17.9345 15.7768 13.9856 -18.469 -1.14955 -2.42085 +571 1 13.1468 0.885591 16.7291 -10.7864 15.024 2.10847 +572 2 14.1008 0.813897 16.7431 10.5998 -4.62802 3.60151 +573 2 12.8375 18.6536 16.4909 -4.88764 -9.34618 2.57866 +574 1 10.8908 14.4992 7.43136 -2.2343 -7.03539 12.0134 +575 2 10.0835 14.2065 7.92308 22.5278 2.1252 -13.3834 +576 2 11.6003 13.8396 7.60224 -11.7269 11.3777 -3.99947 +577 1 17.6181 8.42363 2.12766 -11.9935 -3.6797 -6.77545 +578 2 16.7343 8.37762 2.55285 14.0369 1.72981 -7.6286 +579 2 17.5632 7.81953 1.35766 3.76606 6.32419 13.0143 +580 1 12.3929 7.83138 2.01819 4.71096 17.5308 0.40727 +581 2 12.1717 8.7272 1.7221 -1.13772 -2.1217 4.67191 +582 2 11.9464 7.25327 1.39471 0.282935 -6.68024 -6.10503 +583 1 12.0275 14.6478 10.4009 38.9809 -24.2439 -10.9711 +584 2 12.337 14.044 9.6932 -4.28518 13.1756 12.472 +585 2 11.1105 14.7441 10.2592 -43.0899 4.37787 -4.57767 +586 1 6.8265 6.93238 15.5327 -27.6581 -7.97269 5.64053 +587 2 7.73103 7.08984 15.3178 26.4357 1.09681 -7.32033 +588 2 6.59533 7.63547 16.1384 -2.46814 3.13878 5.80205 +589 1 7.96021 4.51991 13.281 5.98272 36.635 4.98876 +590 2 7.18773 4.72006 12.7149 7.22552 -5.34662 5.9239 +591 2 8.2239 5.40342 13.6709 -8.7699 -31.8396 -11.1478 +592 1 13.3799 12.1942 14.3144 0.413244 -2.26196 2.0512 +593 2 13.2473 11.2333 14.3131 -4.23433 1.2327 0.0241848 +594 2 13.7366 12.3802 13.4362 1.03232 3.06063 -1.77089 +595 1 14.6196 9.43974 7.2819 12.1284 19.1611 12.5008 +596 2 15.4631 9.9012 7.50833 -13.143 -10.3991 -7.78335 +597 2 13.9498 9.89967 7.80701 0.241302 -5.62146 -3.59828 +598 1 12.6688 16.8855 3.24635 -1.47445 -34.5545 -0.541717 +599 2 12.9124 17.3724 4.01195 4.0393 16.1159 25.6755 +600 2 12.6994 17.4999 2.53895 -2.71389 24.0914 -25.4271 +601 1 1.00064 7.12258 17.3474 25.8989 -13.4919 10.9638 +602 2 0.199171 6.81692 17.7654 -17.9333 6.12878 2.90109 +603 2 0.781412 7.72916 16.646 -4.92956 7.36441 -13.84 +604 1 12.947 4.88013 15.7213 -21.2986 7.3754 -0.931645 +605 2 13.7769 4.45629 15.8524 19.8874 -20.9291 -0.114876 +606 2 13.1805 5.80207 15.7513 2.74699 20.2475 2.05037 +607 1 2.36441 3.38825 5.1495 13.4973 -9.76059 -50.575 +608 2 1.87697 2.96062 5.81278 -27.3053 -18.1487 33.2377 +609 2 2.7907 4.09602 5.58982 16.1263 32.9476 11.4061 +610 1 8.23368 10.9868 13.6471 -16.5646 12.9957 -7.98974 +611 2 8.32411 10.9316 14.5895 -0.490848 -4.77914 16.6738 +612 2 9.07298 10.6867 13.3074 11.7511 -8.07538 -9.61613 +613 1 13.0107 1.52025 13.2616 -13.3177 -0.0328213 18.9383 +614 2 13.4383 1.61013 12.4179 13.267 -2.68379 -13.3373 +615 2 12.5185 2.34771 13.3673 3.11016 -7.04189 -1.75869 +616 1 6.59377 13.5764 2.15874 -7.12741 11.9903 -27.1264 +617 2 6.00679 13.9468 2.8128 -10.8754 6.0075 10.3445 +618 2 7.2163 13.0692 2.66145 9.56033 -10.8956 7.78491 +619 1 15.8548 6.42593 12.5881 24.8624 13.3217 16.2273 +620 2 16.4838 6.96617 12.0488 -16.1868 -9.65605 6.77151 +621 2 16.2214 6.49686 13.512 -7.09801 -2.27572 -23.2114 +622 1 16.7956 0.692247 9.54535 7.46915 17.7641 2.49637 +623 2 16.5452 18.5156 9.96298 -0.0131793 -20.516 -0.238231 +624 2 16.2976 0.789947 8.72228 -2.61192 -2.24486 -4.75056 +625 1 6.11318 11.627 8.27064 9.91462 44.2797 -2.20509 +626 2 5.35292 11.2978 8.70378 -29.3613 -6.33495 17.8965 +627 2 6.52877 10.8496 7.97791 23.4734 -34.8725 -13.0112 +628 1 2.81389 8.67751 0.381383 10.1752 -8.74242 -1.84173 +629 2 2.33278 8.32184 18.2713 -4.10181 -2.8979 1.44899 +630 2 2.25425 9.35695 0.757627 -6.74555 6.18422 5.10447 +631 1 10.1136 10.3815 6.5683 -3.97178 -1.84722 1.40214 +632 2 10.6776 9.73953 7.0164 -1.23094 -3.31757 4.86865 +633 2 10.3499 10.3203 5.64027 4.41826 3.29106 -4.73543 +634 1 6.84727 15.7748 6.6764 -14.7135 -11.7826 9.04786 +635 2 7.02398 16.1904 7.53289 5.38031 2.81892 -3.47781 +636 2 6.91879 16.4549 5.99719 9.07918 3.78678 -4.16926 +637 1 6.52182 12.8956 5.7943 0.541827 3.55761 1.99739 +638 2 6.55778 13.7774 6.19915 3.14226 -1.33255 -2.96851 +639 2 6.13082 12.3068 6.44859 -0.859963 5.03094 3.84811 +640 1 16.7567 12.5314 9.76383 -4.64367 0.23861 8.75508 +641 2 16.9908 11.8798 9.10281 -4.06168 -8.34407 -5.30318 +642 2 17.2898 13.2837 9.5332 2.7418 12.1851 0.697411 +643 1 6.23186 2.86269 2.75104 2.97881 8.48666 -1.38882 +644 2 6.52094 3.78037 2.52233 -11.0321 -17.6889 -1.77294 +645 2 5.63962 2.52843 2.04764 8.59188 6.36028 2.68011 +646 1 10.7835 3.03466 3.2504 -5.97107 -1.61798 -4.71292 +647 2 10.2628 3.82076 3.45136 1.61481 0.158577 0.983482 +648 2 10.306 2.59283 2.52669 4.73542 2.88639 2.9637 +ITEM: TIMESTEP +80 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.82629 6.70343 17.8553 -15.1071 8.15122 13.6853 +2 2 7.99416 6.85162 18.349 10.9787 -1.12299 -6.8679 +3 2 8.57507 6.09547 17.1643 3.5075 -8.11573 -6.04158 +4 1 0.137192 8.33532 6.74353 12.0191 -20.4001 -6.39938 +5 2 0.250097 8.10589 5.79669 -2.0008 6.10915 10.6578 +6 2 0.653601 7.63933 7.2162 -12.3825 18.3147 -3.0068 +7 1 8.60149 0.29664 6.93203 12.1667 -9.17994 12.1946 +8 2 9.52501 0.228788 6.64808 -5.75422 4.1152 -0.42095 +9 2 8.21226 0.977159 6.3883 -5.16274 6.48178 -7.47064 +10 1 6.50463 1.68869 11.7262 -16.2706 -7.92373 -2.85274 +11 2 5.9813 2.3145 12.2428 -2.71472 -2.47934 -1.80386 +12 2 5.86927 0.986784 11.4354 16.7384 10.0214 6.53226 +13 1 6.9131 5.55027 2.37535 3.77295 -5.39511 9.11334 +14 2 6.43692 5.84081 3.17655 -0.921031 3.98795 -14.1822 +15 2 6.69543 6.14979 1.6478 1.12895 -1.48609 4.32855 +16 1 16.196 10.2371 16.1388 -31.5516 2.77844 19.9706 +17 2 16.8915 10.3643 15.5412 37.4 6.14414 -23.2997 +18 2 15.8469 11.1288 16.3108 1.55641 -10.2432 -3.37881 +19 1 10.775 14.9631 2.31622 -5.5944 -0.094079 7.63582 +20 2 10.598 14.4521 3.12767 5.78422 3.02899 -5.84463 +21 2 11.1066 15.8146 2.64245 2.43259 -3.51347 -1.1859 +22 1 17.165 8.21001 10.8825 14.1674 -5.9779 -9.25967 +23 2 16.5809 8.83567 11.3092 -8.03296 12.2385 6.15632 +24 2 17.9797 8.71133 10.6858 -5.20793 -0.650283 -1.86008 +25 1 14.6097 15.9558 16.401 14.8916 -7.54315 9.24646 +26 2 13.6847 16.2494 16.4321 3.25844 -2.02272 0.00765398 +27 2 14.8063 15.4932 17.2527 -13.7355 5.39716 -16.4095 +28 1 12.117 13.3155 0.580411 -1.24587 -0.207976 3.78722 +29 2 11.7909 13.4576 18.3369 0.57388 -2.32058 -15.0609 +30 2 11.6242 13.9531 1.10951 4.78037 0.383607 7.31905 +31 1 9.34228 5.488 3.85121 53.6451 1.51077 14.3512 +32 2 8.91013 5.51861 4.6996 -19.4462 -5.34697 10.1126 +33 2 8.70488 5.4763 3.16894 -36.9473 -0.666442 -22.4182 +34 1 1.61615 3.95559 11.5848 -7.57046 15.5603 -11.9076 +35 2 1.66987 4.89506 11.8258 -4.51216 0.523906 3.16779 +36 2 2.10845 3.4705 12.2371 10.5178 -10.3797 12.993 +37 1 2.10284 6.89743 8.15957 -0.837321 -0.675751 7.8246 +38 2 2.47895 7.28827 8.96165 1.07034 3.30836 -6.30935 +39 2 2.071 5.95646 8.37348 -2.86121 -4.48577 -0.939591 +40 1 5.32433 4.44486 7.86972 -1.34052 23.2477 3.45796 +41 2 5.46877 3.5107 7.98026 -0.0649778 -19.4924 -5.7669 +42 2 4.70188 4.60713 7.1427 0.919422 -2.43856 3.29815 +43 1 3.32435 2.88678 17.4197 -1.88929 -9.6261 16.8991 +44 2 4.05816 3.29734 16.977 14.1471 9.33662 -16.3951 +45 2 2.86083 3.59453 17.8818 -3.32176 6.96255 1.50629 +46 1 7.47308 5.51417 6.17701 6.20604 7.73103 -29.885 +47 2 7.95124 6.07722 6.78768 5.01174 3.41934 10.0258 +48 2 7.09189 4.79949 6.66958 -7.20601 -9.71089 14.7057 +49 1 9.80158 6.99902 12.0223 -22.5784 -4.24274 -21.2019 +50 2 10.1069 6.1805 11.5916 -0.00510546 9.67372 7.70676 +51 2 9.03411 7.28611 11.4542 20.6129 -4.31213 14.2424 +52 1 14.1091 3.78361 8.12438 -15.7573 21.5912 -11.6445 +53 2 13.5201 4.50308 7.77049 18.8532 -19.0333 8.38218 +54 2 14.3457 4.04736 9.022 0.199067 1.13361 3.22772 +55 1 4.50215 17.2152 3.88612 2.87802 -1.37968 10.5361 +56 2 5.34021 17.6676 3.86593 13.8498 1.95887 5.68097 +57 2 3.97594 17.6789 3.24294 -11.45 0.485265 -14.6478 +58 1 16.2741 16.534 10.4726 -5.67102 -12.8311 -21.8814 +59 2 15.486 16.5615 11.0293 -1.33881 1.5325 0.205711 +60 2 15.9943 16.0074 9.67798 5.00326 13.1852 19.554 +61 1 1.98121 4.83276 0.125548 -2.90665 -21.863 0.561723 +62 2 2.62989 5.11603 0.769738 5.61812 10.8419 9.00632 +63 2 1.75087 5.59897 18.2498 0.950825 13.4626 -6.91806 +64 1 11.2654 13.2951 16.4195 -4.34554 -2.68737 -1.67212 +65 2 10.7681 12.4683 16.4833 0.87563 -1.05494 5.85319 +66 2 11.8765 13.1105 15.7039 6.19214 3.55339 -6.25188 +67 1 10.1028 10.9035 16.8331 17.2825 8.49241 1.71185 +68 2 10.5205 10.0327 16.7798 -0.767632 10.3686 4.9905 +69 2 9.17724 10.7556 16.7424 -24.4211 -4.37906 -2.41009 +70 1 11.8507 17.4827 13.4696 7.63981 7.03239 -1.88788 +71 2 12.509 16.94 12.9947 -8.02315 8.08552 1.57387 +72 2 12.1795 18.4053 13.408 -3.08283 -9.25718 -0.840972 +73 1 6.44601 9.4433 12.2773 8.37995 -15.986 -34.1351 +74 2 7.00514 9.1357 11.5138 -12.9725 10.8563 23.5312 +75 2 7.03346 9.94503 12.8365 5.04668 8.97956 7.26084 +76 1 16.2979 12.8575 2.71922 -11.7369 16.949 2.19382 +77 2 17.1652 13.221 2.45954 -10.8006 -1.31331 4.0939 +78 2 15.6758 13.6404 2.78783 18.0783 -23.2667 -2.52892 +79 1 0.707968 12.7192 5.87585 -9.46746 -3.17244 -7.34712 +80 2 1.05314 12.7932 4.98248 12.8843 -1.39545 -4.60697 +81 2 18.4375 12.4692 5.68303 -3.12969 3.97578 10.4064 +82 1 5.29671 16.347 18.4316 -9.43352 6.10902 0.949816 +83 2 5.62099 15.5668 17.9615 5.22561 3.70018 3.69326 +84 2 5.92538 16.5961 0.477291 0.486221 -4.47534 -1.04063 +85 1 0.707184 7.70367 4.119 -51.5024 -35.8612 26.1825 +86 2 0.14378 7.97362 3.40377 -12.5647 4.97441 -12.5535 +87 2 1.50957 8.08535 3.91273 65.7491 26.1316 -14.6887 +88 1 3.20348 9.03456 6.50534 -36.9666 27.611 -24.7826 +89 2 3.63112 8.56754 7.174 27.0077 -25.2244 35.3222 +90 2 2.25579 8.96355 6.72902 9.17057 2.1904 -6.46933 +91 1 7.27937 10.3761 16.2413 -0.230914 -4.48303 6.76598 +92 2 6.52755 10.9587 16.1419 -2.56448 5.11938 -3.06937 +93 2 7.11485 9.96393 17.0986 -0.495486 0.80288 1.59662 +94 1 11.0332 0.910989 5.0177 -6.88619 -3.17881 -8.23488 +95 2 10.972 1.75479 4.54866 7.92386 3.49104 7.17877 +96 2 10.6826 0.325395 4.32946 5.79259 -4.26916 6.55693 +97 1 4.2654 2.89302 13.1773 0.694211 20.6748 -2.64105 +98 2 4.39238 3.45448 13.9576 1.0821 -9.7456 0.782255 +99 2 4.16489 1.98946 13.4871 -0.702651 -10.6992 3.24412 +100 1 8.43419 10.272 1.79599 3.30535 -21.7188 -14.6566 +101 2 8.19585 10.8779 2.48837 0.0509316 11.2873 19.613 +102 2 8.53541 9.39344 2.20281 2.46081 9.96427 2.84146 +103 1 10.2486 1.68186 15.4597 -14.9494 5.38019 -3.47887 +104 2 11.0964 1.37036 15.7536 17.388 -0.916576 -1.92962 +105 2 10.2694 1.89097 14.5087 2.57313 -1.10767 6.05091 +106 1 2.6143 12.7739 7.92246 0.947228 -0.997667 -1.9326 +107 2 3.16975 13.4683 7.54148 -0.729705 2.73148 -0.490338 +108 2 1.96608 12.5591 7.23618 1.36975 0.244975 0.56737 +109 1 3.86268 11.7535 5.00307 -14.4028 -3.16999 8.33757 +110 2 3.70976 11.1475 5.74815 1.12966 3.67823 -8.44516 +111 2 3.06255 11.7297 4.44022 7.7842 4.67892 9.37694 +112 1 6.76061 14.5167 16.9537 -0.888094 -7.58336 -2.84579 +113 2 7.48488 15.1306 17.0914 4.64858 -1.1877 -1.93173 +114 2 6.56705 14.5225 16.0035 -2.02875 6.77169 3.29706 +115 1 14.2034 14.5245 3.20058 -0.0398844 -12.3077 5.38397 +116 2 13.8793 15.4221 3.34301 -5.62621 -2.27359 -1.58508 +117 2 13.7959 13.9448 3.87781 2.42748 11.415 -6.18352 +118 1 8.70505 18.0887 16.0942 -64.5065 -8.09898 -3.91687 +119 2 9.21396 17.4083 16.5058 25.0639 -11.349 2.42178 +120 2 9.16407 0.206988 15.7928 30.835 22.2192 -2.21878 +121 1 4.63692 1.68417 4.88655 37.1566 -9.63698 -3.58798 +122 2 3.87701 2.22405 4.82391 -30.2785 19.7734 3.84799 +123 2 5.28246 2.1077 4.29595 -5.87377 -5.36693 3.35208 +124 1 15.0131 12.6297 16.4887 -20.293 3.22713 36.7225 +125 2 14.5244 12.6173 17.3484 21.3151 5.53737 -15.2497 +126 2 14.2857 12.586 15.869 -0.208138 -0.973548 -24.0506 +127 1 15.729 18.4304 16.8576 -8.95075 23.4819 -17.3869 +128 2 16.2245 18.5231 17.6612 15.7889 -2.20706 14.0604 +129 2 15.4698 17.5226 16.786 -7.06215 -23.0828 1.02158 +130 1 1.394 1.31209 16.6703 -16.8241 -3.16738 2.04331 +131 2 2.15084 1.87826 16.8449 0.715689 -4.34048 -2.49358 +132 2 0.715561 1.66179 17.2756 6.00571 -5.18273 -5.07353 +133 1 18.2252 4.3402 15.9772 -8.55569 -2.73 -13.6324 +134 2 17.823 3.76125 15.3072 5.10239 5.23383 8.49054 +135 2 0.492866 4.4785 15.7127 2.39871 -0.864238 1.29175 +136 1 12.1265 17.032 16.1255 -25.5416 -7.58495 15.967 +137 2 11.3669 16.5924 16.5691 16.6277 5.86514 -1.80192 +138 2 11.8242 17.0598 15.2127 8.00105 4.8532 -10.0676 +139 1 16.1291 2.68344 18.211 0.375456 -13.3929 15.5569 +140 2 15.6138 3.3874 18.6109 -0.098248 15.4546 -4.83257 +141 2 15.8549 2.61026 17.3068 -10.5356 1.78345 -20.9571 +142 1 6.60182 13.7939 10.068 9.2492 3.65708 4.18485 +143 2 6.57275 13.4224 10.9661 -3.78941 -3.14938 -5.19226 +144 2 6.71396 13.0652 9.44214 -7.17216 -3.95227 2.85982 +145 1 10.1302 18.5571 2.70452 28.7428 2.61674 -1.08827 +146 2 10.6588 0.134354 1.90491 -8.77267 0.774664 16.1596 +147 2 9.28539 18.2699 2.40893 -22.5926 -9.32297 -10.0302 +148 1 3.0625 17.7033 6.15366 -32.6923 -3.28618 14.6113 +149 2 2.13754 17.6931 5.7562 38.9757 -0.864197 5.33283 +150 2 3.7049 17.7316 5.44436 -0.964713 0.371031 -13.1926 +151 1 12.6087 16.7853 7.93012 21.3772 -3.32102 -23.3093 +152 2 11.8409 16.2517 7.71322 -11.0279 -6.8961 6.738 +153 2 12.4183 17.3739 8.65053 -14.1479 13.0972 16.1976 +154 1 14.9031 15.2939 8.2802 -30.4011 23.5185 11.3145 +155 2 14.1656 15.9721 8.20757 23.4522 -23.8051 0.0341398 +156 2 15.3634 15.3182 7.4362 3.9964 4.48103 -1.46252 +157 1 17.8706 18.2596 0.245663 2.0948 -17.0514 -11.0411 +158 2 18.6148 17.6985 18.5349 -15.5847 20.6608 16.06 +159 2 18.229 0.448391 0.574358 6.37924 -1.254 -0.87753 +160 1 0.806491 10.487 1.42673 -7.2326 -9.98023 10.4462 +161 2 -0.00161399 9.98055 1.66044 10.6613 4.25192 -4.69396 +162 2 0.557346 11.1929 0.820979 -4.09494 2.43397 -4.83249 +163 1 1.83456 12.2686 3.29043 -8.34448 2.57963 -8.45001 +164 2 1.36787 11.5875 2.7525 13.033 10.6511 2.37549 +165 2 2.15971 12.967 2.6794 -8.27007 -10.3927 7.15994 +166 1 0.688934 17.2807 4.96532 -1.28513 13.5074 -14.6034 +167 2 -0.0176841 17.9487 5.11769 8.40666 -17.1979 3.35047 +168 2 0.596617 16.4414 5.43231 -12.6974 4.79178 9.39957 +169 1 1.09014 0.907525 9.3383 6.29421 1.3921 30.3575 +170 2 1.25758 0.656293 10.2983 -10.9635 5.07818 -25.2558 +171 2 0.281108 0.475301 9.05696 -4.67463 -4.0945 4.23309 +172 1 16.7684 2.39691 13.3495 9.61769 42.5491 2.72371 +173 2 16.904 2.78957 12.4595 -0.731435 -13.0756 10.2936 +174 2 16.527 1.48948 13.2642 -5.98641 -27.7824 -4.48506 +175 1 2.71373 15.9459 12.053 -3.75115 0.267025 20.4445 +176 2 2.98439 15.5717 12.9162 -2.14108 4.62523 -16.3505 +177 2 3.30112 15.6057 11.3695 4.80572 -2.00813 -1.58569 +178 1 16.3912 15.5658 6.1364 -18.5193 -23.7813 -1.39285 +179 2 17.3153 15.4712 6.31079 23.2449 0.130836 8.54259 +180 2 16.3263 16.278 5.5153 -3.20698 17.7917 -15.4301 +181 1 5.73039 5.21537 11.7967 -2.24013 5.33831 8.85226 +182 2 5.58704 6.03693 12.3192 -1.36073 -15.5687 -10.3459 +183 2 5.0707 4.59019 12.1393 4.45693 0.898588 -6.68224 +184 1 15.134 4.90094 0.781902 20.2218 -12.3751 4.08616 +185 2 14.9115 4.68422 1.69179 -1.28767 -2.72314 10.4735 +186 2 14.3889 5.35469 0.437757 -23.5901 14.4279 -10.7703 +187 1 16.3592 16.4594 1.89384 25.1746 19.6936 -18.9686 +188 2 16.2469 16.8 2.79117 -6.86302 3.67352 0.481682 +189 2 16.829 17.1783 1.36994 -16.7874 -21.2348 17.437 +190 1 0.175681 4.85349 3.94905 -38.6563 1.2533 -4.07114 +191 2 0.373462 5.78529 3.89581 11.5619 13.3417 2.94095 +192 2 0.969717 4.36237 4.02266 30.2668 -11.0427 7.4994 +193 1 2.99204 15.0813 15.1763 -0.305205 14.4793 -34.7595 +194 2 2.88713 14.6595 16.0135 -9.94348 -6.29569 26.5741 +195 2 2.4481 15.8945 15.1967 6.07768 -3.34342 6.9782 +196 1 1.12287 14.6661 9.5226 42.1359 23.511 16.8308 +197 2 2.04871 14.8527 9.88052 -40.3465 -4.39318 -17.9218 +198 2 1.08708 13.7187 9.50981 -4.88478 -15.9854 1.2011 +199 1 13.5299 16.5144 11.5405 11.2356 18.9117 4.33104 +200 2 13.1159 17.2557 11.0661 2.81218 -0.6798 2.92705 +201 2 13.1037 15.7572 11.1579 -10.8238 -16.1215 -4.14744 +202 1 4.70977 1.52963 0.718559 3.58248 -24.4192 11.8527 +203 2 4.08939 1.89433 0.0933404 -5.33693 14.3563 -9.66083 +204 2 4.20955 0.796838 1.1277 3.32575 8.01941 1.68952 +205 1 1.50238 18.6141 11.9042 -1.38031 13.5472 16.8753 +206 2 1.45658 0.425239 12.7856 -0.241625 -6.75063 -24.7438 +207 2 2.14944 17.9089 11.9973 -1.06457 -6.06855 3.15913 +208 1 11.4462 10.1354 4.10554 -27.8103 0.519562 13.0103 +209 2 11.5399 10.6236 3.29381 1.04561 4.25273 -17.1067 +210 2 12.3232 9.96387 4.39943 30.3669 -4.33072 3.08727 +211 1 8.16113 12.1728 3.80004 4.97071 -3.14572 14.2587 +212 2 8.9952 12.5305 4.11747 11.4774 1.91239 -11.4095 +213 2 7.64202 12.24 4.61417 -11.8418 -2.63078 -6.07404 +214 1 14.5844 4.03291 3.36716 -4.11232 -3.55002 -24.3582 +215 2 15.2517 4.33672 3.97304 10.7234 0.0718586 14.5399 +216 2 13.7453 4.32617 3.71649 -8.9869 4.72015 4.68372 +217 1 5.72064 1.64489 7.5839 32.9059 28.6425 0.0988457 +218 2 5.06921 1.12259 7.98588 -34.2591 -28.2453 24.4599 +219 2 5.39575 1.74393 6.6993 -3.28926 -2.3453 -25.2911 +220 1 17.8815 1.07824 4.83341 -4.77439 -8.44394 -0.469265 +221 2 18.4195 1.29399 4.06103 3.32925 4.9906 2.38586 +222 2 18.1973 1.60106 5.58304 1.56226 2.04575 -0.708791 +223 1 6.854 9.3046 4.53528 10.3956 -9.62802 3.27507 +224 2 6.69426 9.36632 5.492 2.76918 3.19153 -6.51095 +225 2 7.80605 9.0738 4.45229 -13.5827 1.70924 -0.808399 +226 1 2.59539 14.8276 2.04954 -21.4179 -5.20739 -34.911 +227 2 3.34516 14.7063 2.60932 22.2061 -1.352 15.1427 +228 2 2.90646 14.7931 1.11821 -3.29515 2.22824 22.2692 +229 1 17.3057 12.9587 13.1574 -14.3584 11.8265 -1.68619 +230 2 16.4238 13.3017 13.4505 21.6076 -1.54195 -11.2195 +231 2 17.8123 13.7306 12.814 -13.7958 -9.76612 7.37248 +232 1 14.8715 10.5568 1.52593 -13.8049 33.9422 19.399 +233 2 15.3968 11.3309 1.89043 -12.48 -24.7346 -11.1652 +234 2 13.9264 10.776 1.72699 26.333 -7.21409 -8.066 +235 1 5.65075 6.69227 4.53589 -1.16643 0.470211 -4.08107 +236 2 5.90168 7.60385 4.33311 1.92457 3.57872 5.04239 +237 2 6.31691 6.35225 5.15026 1.24698 1.28263 2.78678 +238 1 8.00933 8.29789 10.2803 -8.03608 2.46456 2.45807 +239 2 8.54459 8.86115 9.67988 -10.051 -7.82575 5.32423 +240 2 7.18397 7.98917 9.84875 17.8376 0.213066 -8.74409 +241 1 13.4452 18.4811 5.71348 30.3006 1.0471 -14.1486 +242 2 12.642 0.299737 5.48582 -19.0854 8.92614 -0.688815 +243 2 13.1967 17.7426 6.25238 -10.7462 -10.7439 19.4962 +244 1 -0.0119027 2.59488 0.354931 35.8038 -39.8932 13.3955 +245 2 17.7273 2.51611 0.10594 -24.5443 11.4005 -8.19311 +246 2 0.27212 3.48779 0.285479 3.99253 30.2779 -6.4317 +247 1 12.849 10.869 9.75158 -6.21929 20.5855 -7.88953 +248 2 11.8713 10.9784 9.78619 15.6811 -13.8069 -0.457669 +249 2 13.0615 9.92753 9.83861 -13.7986 2.36182 2.76964 +250 1 0.623186 12.214 11.083 4.78072 12.4497 9.66308 +251 2 18.3291 12.2937 11.2784 -7.07035 -2.86266 -6.1852 +252 2 1.03568 12.566 11.8864 5.16139 -3.44089 -5.05626 +253 1 5.24317 7.35288 13.329 16.5645 10.6427 9.86574 +254 2 5.81232 8.06371 12.9598 -16.2044 -6.02954 3.80806 +255 2 5.63373 7.21351 14.2126 -3.74153 -4.80134 -10.81 +256 1 1.17457 6.8033 11.9036 -23.8679 10.4664 -9.71638 +257 2 0.289623 7.06715 11.5324 26.398 -8.64759 11.7652 +258 2 1.56564 7.61974 12.2537 0.753648 -2.9175 -1.70229 +259 1 15.4919 9.76734 12.3795 0.0614124 -7.36309 3.05776 +260 2 15.0846 10.6319 12.2391 7.36463 -2.83561 -3.47144 +261 2 15.8873 9.82027 13.2467 -0.105969 -0.524429 6.2821 +262 1 16.5022 12.5635 5.51418 5.92626 -4.93161 -13.1981 +263 2 16.3002 13.4761 5.69188 -2.75562 16.3616 9.80459 +264 2 16.3759 12.5305 4.55079 1.66896 -8.7704 1.12914 +265 1 6.31756 9.85145 0.122373 -12.0354 8.37982 6.54531 +266 2 5.4699 10.2439 0.423151 12.3884 -4.45977 -3.2374 +267 2 6.98984 10.1338 0.758446 2.49067 2.04662 0.271789 +268 1 12.1918 6.08954 4.01066 -16.388 -25.9861 2.6766 +269 2 12.1912 6.72626 3.29268 0.559249 7.6643 3.09763 +270 2 11.3251 5.63233 3.94387 14.2823 13.1494 2.08097 +271 1 0.332379 12.8663 0.0441745 0.0508304 2.00456 8.93046 +272 2 18.9019 13.5185 0.756349 -7.27218 -2.99587 0.981784 +273 2 18.3327 13.1573 18.0278 2.80865 -1.79272 -4.8195 +274 1 3.54313 0.0443203 8.66238 11.9606 -6.13667 -3.48184 +275 2 3.32458 18.1774 7.87344 8.237 1.02812 -5.83338 +276 2 2.68777 0.391851 8.89446 -8.31408 9.03305 4.42594 +277 1 7.44404 17.5122 4.49167 0.119683 3.6114 3.91179 +278 2 7.85567 18.3869 4.65486 -14.0238 -13.6963 -7.23825 +279 2 7.39901 17.3877 3.53399 5.58618 2.96743 1.37553 +280 1 9.26713 17.153 12.2094 -20.2295 17.8608 7.81194 +281 2 9.28392 16.3133 11.7674 1.3049 -15.888 -12.5165 +282 2 10.076 17.208 12.7094 15.0452 0.291548 7.10451 +283 1 13.4068 13.0832 7.92217 -6.10698 -2.73533 15.5952 +284 2 13.4694 12.4257 8.66119 -0.459118 13.24 -15.7611 +285 2 13.8946 13.8972 8.17425 4.86633 -17.7849 -1.17812 +286 1 14.7977 2.95386 15.4326 21.7471 11.1646 11.1554 +287 2 14.1505 2.32893 15.1446 -13.9872 -17.9607 -8.38755 +288 2 15.4352 3.02911 14.7173 3.23846 -4.77681 -7.04868 +289 1 9.91022 15.6467 16.9338 -7.88269 11.4297 -3.43074 +290 2 10.0979 14.7902 16.532 6.40878 -6.10819 3.84543 +291 2 9.43747 15.4751 17.7557 1.6004 -7.26983 6.6271 +292 1 11.2148 8.51865 16.6243 -9.14606 -19.2231 -14.9185 +293 2 10.4285 8.06123 16.2547 13.8022 0.848227 5.21642 +294 2 11.6642 7.88268 17.1928 -1.33785 -0.880144 3.29074 +295 1 3.96477 18.2022 16.8388 0.151724 27.8243 14.0652 +296 2 4.47646 17.6367 17.4198 3.54357 -14.0579 0.0762873 +297 2 4.08749 0.446059 17.2373 -6.51294 -16.617 -15.0442 +298 1 2.23636 4.23466 8.90617 11.6474 4.96614 0.176633 +299 2 3.18727 4.06881 8.84702 -5.0902 0.586039 -2.82984 +300 2 2.03755 4.18072 9.84669 -2.61694 -5.47133 1.10155 +301 1 9.89683 10.3797 9.78633 12.6385 -21.4053 -24.2531 +302 2 9.49137 11.1552 9.42946 -10.1833 20.5571 -3.63947 +303 2 9.86232 10.3926 10.7266 0.554165 3.61624 28.8421 +304 1 9.72109 0.91625 10.832 13.6195 9.02414 1.59857 +305 2 9.21789 0.206273 11.2536 -3.38139 -4.49977 -6.76529 +306 2 9.17946 1.37162 10.1615 -3.40595 -8.11879 6.74876 +307 1 9.15707 15.1255 10.1914 20.6551 -3.22149 9.33909 +308 2 9.01609 15.916 9.68312 -8.41387 13.877 -8.61246 +309 2 8.34011 14.6408 10.1195 -14.233 -7.19689 -0.719266 +310 1 0.808146 9.70808 10.2086 23.84 -38.9856 -20.0319 +311 2 0.930598 10.6496 10.3444 5.65872 6.03362 4.8682 +312 2 1.64643 9.29884 9.83207 -32.5144 23.6532 16.8406 +313 1 17.0698 4.80337 8.05752 27.8638 -35.1931 -3.66362 +314 2 16.2966 5.30586 8.21629 -27.2809 18.9512 9.97555 +315 2 16.9993 3.9693 8.55928 -0.62818 15.8913 -5.61459 +316 1 14.8223 14.6574 0.153467 -11.4546 -14.4551 -9.90243 +317 2 15.436 15.0274 0.766448 14.8773 15.1477 17.5942 +318 2 14.121 14.2916 0.705806 -3.92817 0.026116 -2.07816 +319 1 3.85634 11.0156 9.57857 3.75671 2.20251 0.903354 +320 2 3.89754 11.3203 10.4983 -5.37308 2.01291 2.42961 +321 2 3.35837 11.6719 9.06911 -6.8083 1.73507 0.204751 +322 1 11.3728 10.7464 1.42992 33.2497 -4.81825 9.44885 +323 2 11.5281 11.6383 1.10055 0.915848 5.55374 -4.33141 +324 2 10.4426 10.6155 1.47257 -31.1398 -0.627116 -5.41705 +325 1 13.1828 7.20447 12.6676 -0.0478479 -14.2604 -0.4669 +326 2 14.1298 6.99811 12.5505 -7.76827 -0.67018 4.43892 +327 2 12.735 6.32848 12.7534 7.45412 15.7346 -2.47341 +328 1 9.63194 1.91441 0.890304 3.16134 4.31897 -8.70512 +329 2 8.77158 1.63222 0.526893 10.8452 7.48256 0.350857 +330 2 10.2032 2.19638 0.151243 -8.90992 -2.48069 6.74103 +331 1 10.6318 13.4626 4.55882 -11.5056 -1.99047 12.5083 +332 2 11.4876 13.0509 4.71851 7.47615 -1.29416 -2.63952 +333 2 10.4232 13.8662 5.41293 0.691023 4.41994 -1.81408 +334 1 14.5517 1.66181 10.9802 -11.5576 12.9 9.45395 +335 2 15.3776 1.3055 10.6442 8.04202 2.4344 -3.19562 +336 2 14.6907 2.6148 11.169 4.38713 -8.31284 -15.1855 +337 1 14.4901 12.0498 11.5809 -31.454 -4.77499 25.6083 +338 2 15.091 12.4736 11.0015 28.7023 12.1919 -21.8177 +339 2 13.8321 11.6274 11.0162 -1.74489 3.16984 -4.97875 +340 1 8.17369 5.13537 9.87952 -12.8505 7.96449 12.3464 +341 2 7.30162 5.126 10.3345 14.626 0.500686 -8.94194 +342 2 8.32701 4.24033 9.57061 -3.03583 -8.79147 -1.32617 +343 1 1.61182 16.9829 18.4557 19.3906 15.8485 -25.2691 +344 2 2.09739 17.4464 17.7224 -9.17701 -12.9822 18.3353 +345 2 1.80792 16.0477 18.3234 -0.14796 -4.92565 -1.79656 +346 1 1.43858 17.3769 15.3174 -8.9259 8.94647 7.52005 +347 2 1.45812 18.1702 15.9147 -6.93156 -15.9408 -17.1792 +348 2 0.507347 17.0882 15.1685 14.4449 8.30676 8.33907 +349 1 3.5257 5.78471 6.06613 -3.39677 -13.3058 1.89016 +350 2 2.9753 6.46227 6.46115 -3.38454 1.41808 7.55669 +351 2 4.15739 6.26663 5.53865 9.2569 4.30143 -12.1591 +352 1 12.629 9.51298 14.2604 -9.77978 19.3775 3.35531 +353 2 12.9437 8.76225 13.7938 15.2815 -22.6591 -22.819 +354 2 12.3447 9.10922 15.0729 -6.56341 1.36458 18.6396 +355 1 4.0928 15.2431 7.0497 -2.25109 -22.7738 13.7055 +356 2 3.66448 16.0653 6.81785 -2.80743 13.3283 -7.68 +357 2 5.04695 15.3859 7.01583 3.36741 6.66555 -6.63338 +358 1 0.780201 8.79903 15.0924 -4.1065 -28.223 6.26572 +359 2 0.548696 9.72105 15.1288 -1.34907 18.7642 -4.10325 +360 2 1.5752 8.72345 14.5481 -0.207921 7.22304 -3.82448 +361 1 12.9286 8.29499 10.1476 33.3114 -28.911 32.5654 +362 2 13.7554 7.80683 9.90421 -18.1809 10.2081 -7.43875 +363 2 12.9042 8.10572 11.1188 -9.83308 4.93442 -19.3471 +364 1 15.2998 7.93844 3.50826 -21.0939 -7.00262 -11.8412 +365 2 14.4558 7.58878 3.24395 -11.6977 10.4201 -28.099 +366 2 15.3831 7.3862 4.26257 30.2163 -1.92794 33.2483 +367 1 17.18 6.71526 18.6425 -0.133844 12.8911 -12.7702 +368 2 16.7451 5.93694 0.322596 -6.25651 -15.7248 7.28694 +369 2 16.4413 7.25778 18.3094 9.30548 1.37884 5.01187 +370 1 8.9084 6.99396 7.88573 -0.881002 2.32267 0.0260346 +371 2 9.83584 7.2627 7.79742 -0.0847644 -0.13812 3.11438 +372 2 8.83558 6.46246 8.69404 -0.0294368 0.694249 -1.22754 +373 1 12.437 0.501834 1.22358 -0.716997 -8.58934 -9.29719 +374 2 13.1312 1.05983 1.5788 8.89791 0.478791 5.50433 +375 2 12.732 0.307907 0.326573 -3.73597 1.67796 1.81541 +376 1 5.69458 15.0516 14.5143 3.69591 -14.2553 -4.53333 +377 2 4.76954 15.0969 14.776 -8.31751 1.66253 0.63197 +378 2 5.95328 15.9515 14.3109 5.80865 11.3045 -3.56535 +379 1 3.78081 6.42509 1.75203 4.2348 -8.30075 -4.29513 +380 2 3.33672 7.18396 1.37288 -3.60544 13.0853 -6.67388 +381 2 3.84967 6.63422 2.68491 0.545892 0.795555 6.86444 +382 1 3.88792 11.3989 12.3546 13.0971 -5.24635 -8.64578 +383 2 4.74838 11.8202 12.5261 -6.66532 -1.91753 0.168546 +384 2 3.23677 11.927 12.8169 -5.64663 9.70313 4.55872 +385 1 5.30252 3.85246 15.7701 3.45242 11.6571 4.53522 +386 2 6.06202 3.27771 15.61 2.30678 -4.65184 -5.35711 +387 2 5.68598 4.72788 15.9368 -2.89319 -4.23448 -3.12102 +388 1 14.1378 10.1309 4.62741 -6.40911 2.93718 -21.1253 +389 2 14.285 9.82325 5.50803 7.98673 -9.05047 24.7099 +390 2 14.6717 9.53242 4.07811 -2.84302 6.29722 1.17771 +391 1 7.65634 17.3346 9.10408 10.3132 -24.7491 -1.74792 +392 2 7.07794 17.6856 9.78277 -9.16436 8.21537 0.604828 +393 2 7.96278 18.0151 8.50473 -0.553145 15.1908 -4.94918 +394 1 4.52232 14.5173 3.95827 12.1345 -25.6108 -47.7046 +395 2 4.42958 15.3956 4.25649 -1.76895 36.8878 18.7873 +396 2 4.4098 13.9051 4.66351 -3.8607 -15.3504 25.5968 +397 1 14.1258 7.45828 15.8364 -6.23365 -6.73609 3.75314 +398 2 14.9302 7.39167 15.3277 7.57838 -0.290505 -5.08612 +399 2 14.4287 7.78058 16.69 -2.09073 5.34234 4.78248 +400 1 2.95098 18.3751 1.91859 -29.5535 -1.78839 -16.8987 +401 2 2.45071 17.8858 1.20736 17.1758 4.42604 21.0133 +402 2 2.2449 0.246547 2.36374 11.8246 -5.6794 -7.15496 +403 1 7.99154 1.5773 4.49846 30.6245 -5.45524 3.73918 +404 2 7.42382 1.97686 3.83614 -1.09908 5.00667 -8.45405 +405 2 8.90683 1.55308 4.13454 -22.7919 6.21994 3.05753 +406 1 2.44336 14.1732 17.7263 2.89693 8.8065 2.99283 +407 2 1.80182 13.5359 18.0713 -0.462046 0.279758 -5.24045 +408 2 3.30188 13.814 17.96 10.6791 -8.66055 4.12847 +409 1 0.94217 1.90899 13.8934 13.5408 -1.52741 -1.05885 +410 2 1.19747 1.57322 14.7589 -4.95142 3.16298 5.50662 +411 2 18.6373 2.03702 13.8998 -8.7871 -0.483879 -2.02084 +412 1 4.30938 0.151078 13.8855 7.43827 7.09651 -9.2822 +413 2 5.23906 18.5299 13.9426 -3.76642 -3.92995 -1.86801 +414 2 3.88869 18.4591 14.673 -3.49259 -4.03929 12.0029 +415 1 7.32054 0.93366 18.4163 -33.3446 -10.4004 5.92831 +416 2 7.32153 0.654144 17.4916 5.03052 -1.00997 0.0977128 +417 2 6.36163 0.937686 18.6972 26.0729 9.45288 -6.86634 +418 1 15.8933 18.4156 13.9169 -22.9956 8.12347 -47.8741 +419 2 14.9583 18.5802 13.6337 24.0447 -6.26997 16.1472 +420 2 15.9487 18.2637 14.8423 -3.56821 2.97357 29.888 +421 1 10.2651 4.57121 16.2688 1.93413 -35.0494 -13.7078 +422 2 11.2092 4.46181 16.4883 -7.31309 8.12251 -3.69007 +423 2 10.0229 3.6678 15.9192 2.49448 27.3645 14.4368 +424 1 15.9059 17.707 4.46041 -10.2591 -26.7612 -3.24664 +425 2 16.489 18.4443 4.44561 19.3223 26.1038 4.21423 +426 2 15.1093 18.0276 4.88994 -9.23113 3.77657 -1.20249 +427 1 6.91304 17.5561 13.9404 -32.5423 1.81832 8.8205 +428 2 7.45718 17.7359 14.6891 13.6263 3.56972 27.349 +429 2 7.55119 17.4736 13.2627 22.9256 -5.60471 -32.7019 +430 1 13.1887 6.46821 6.52506 2.14134 -6.99498 -16.9539 +431 2 14.1468 6.55272 6.36688 -10.1834 4.86047 2.66897 +432 2 12.7776 6.33144 5.63446 11.1073 4.86992 20.3892 +433 1 7.86929 2.3014 9.43186 -7.43999 -0.581733 -7.42672 +434 2 7.28758 2.26368 10.206 1.54253 -4.13193 1.23421 +435 2 7.37428 1.85692 8.71867 3.17855 7.90221 2.8646 +436 1 15.2039 14.7441 13.779 -1.62406 2.57688 -1.70285 +437 2 14.9354 14.9492 14.6806 -4.8726 3.09257 3.44485 +438 2 14.7582 15.3762 13.1995 0.661267 -3.02741 1.58802 +439 1 9.4149 8.38535 3.859 -25.1665 -10.991 -5.57318 +440 2 10.2049 8.88585 3.99067 20.2759 12.8236 2.22258 +441 2 9.67249 7.46496 3.96553 -1.56288 -2.67339 -2.00262 +442 1 17.7026 13.5834 16.4242 -1.80346 -11.0476 6.4727 +443 2 16.7549 13.3713 16.3986 -0.662501 7.25922 -2.44544 +444 2 17.8485 14.4294 15.9813 -4.13054 1.45271 -4.35383 +445 1 4.91191 10.5224 2.88074 35.1139 -21.7488 -13.7776 +446 2 5.74832 10.1175 3.20879 -18.1595 7.39309 -6.65206 +447 2 4.64711 11.0636 3.60968 -4.98951 12.9254 11.8317 +448 1 3.70989 8.40692 9.9178 -3.43098 -13.3807 16.77 +449 2 3.72102 9.34916 9.72654 3.49477 5.64054 -2.09668 +450 2 3.74613 8.34545 10.8924 -2.49133 1.09455 -12.0955 +451 1 15.9811 6.93645 5.90716 -9.64967 -5.56515 0.983492 +452 2 16.7246 7.40088 6.29715 7.31355 3.31596 3.21676 +453 2 16.2311 6.00551 5.84179 2.78737 3.87161 -3.53071 +454 1 15.2416 7.2288 8.97537 -25.1477 -13.3308 -14.4253 +455 2 15.9965 7.60799 9.37505 30.1105 10.4166 22.3283 +456 2 15.0439 7.80906 8.23828 -3.19363 1.15625 -6.55237 +457 1 6.20437 12.8345 12.7354 -14.1465 10.1654 -16.7884 +458 2 6.94522 12.3758 13.1101 18.4885 -10.5564 10.7987 +459 2 6.04629 13.6348 13.2503 2.66058 2.52169 8.79246 +460 1 12.1262 4.55048 13.1243 17.0811 13.049 12.1055 +461 2 12.3395 4.65477 14.0809 -9.37635 -6.07885 -14.152 +462 2 11.329 4.03313 13.0256 -8.31182 -5.5816 3.57791 +463 1 11.4354 8.07801 7.94226 -0.810806 3.70784 -8.7596 +464 2 12.2037 7.66847 7.47953 -11.1819 -0.00285319 12.9065 +465 2 11.6202 8.13058 8.89801 9.03316 -1.52538 -12.7532 +466 1 16.9943 10.8342 7.6109 -5.03955 -8.49642 17.9987 +467 2 17.7716 10.3123 7.42961 10.8043 -13.0503 -0.479497 +468 2 16.9113 11.4133 6.86596 -8.14606 13.8231 -19.3584 +469 1 5.21042 18.0585 10.7699 15.6232 7.92267 2.97831 +470 2 4.74775 17.5474 11.4283 -5.6196 -5.04348 5.46467 +471 2 4.57391 18.2408 10.077 -8.01525 -1.2934 -10.8517 +472 1 7.60043 17.4332 1.64042 6.79415 6.05281 -21.827 +473 2 7.93761 16.6332 1.20425 2.91062 0.230192 8.27204 +474 2 7.75711 18.1408 0.980897 -9.32049 -5.6032 10.0359 +475 1 1.93897 12.9382 13.63 3.13689 -3.11692 -16.6768 +476 2 1.43678 12.3217 14.1546 -10.1951 -7.38374 9.42459 +477 2 2.04891 13.7234 14.1672 6.66588 6.79896 5.37665 +478 1 9.3938 6.77683 14.8244 15.3217 -3.43003 -1.39025 +479 2 9.8639 6.00007 15.2423 -8.39432 15.0581 -15.9266 +480 2 9.75443 6.97816 13.9251 -4.83499 -14.7492 16.6004 +481 1 15.2802 4.37234 10.7612 17.1837 -0.598437 7.1821 +482 2 16.2442 4.23454 10.6079 -20.4209 -0.451849 5.19081 +483 2 15.2528 4.98337 11.5249 -0.66536 -5.42981 -12.7574 +484 1 11.4105 6.21551 0.0734026 -8.7314 7.93342 -2.27424 +485 2 11.3895 5.26963 0.0141504 12.2817 -18.3718 -0.889513 +486 2 10.499 6.41528 18.4856 -6.56297 9.87049 -0.998012 +487 1 18.513 11.4235 14.9225 12.9282 -22.681 3.72438 +488 2 17.9895 11.7369 14.1972 -5.90482 9.25399 -19.4183 +489 2 18.3571 12.0937 15.574 -0.537982 14.5307 17.0247 +490 1 7.08328 9.28085 7.30918 -19.7197 4.18214 5.56511 +491 2 6.73297 8.51044 7.78417 1.76821 -0.286333 -7.5509 +492 2 8.01676 9.1548 7.24802 24.3996 -5.081 -1.83944 +493 1 18.3255 15.3437 12.2137 -3.8694 0.735905 0.400418 +494 2 0.599616 15.5 11.9645 6.26195 2.32841 -0.363056 +495 2 17.7995 15.7522 11.5099 -2.40985 0.96637 0.371307 +496 1 16.511 4.37404 5.22763 -21.2214 -5.51878 25.3236 +497 2 16.4647 3.99489 6.12381 2.74309 1.28503 -9.80457 +498 2 17.4303 4.54035 5.0616 22.4703 -0.915278 -13.9933 +499 1 17.7218 3.13981 10.7749 -4.33552 13.9915 6.34554 +500 2 18.6231 3.34836 11.0663 1.21144 -2.68719 -3.11144 +501 2 17.734 2.28626 10.3485 2.99182 -14.4528 -5.38806 +502 1 12.2792 18.655 10.1327 17.2693 -45.8263 -15.1364 +503 2 11.5058 0.449575 10.4425 -26.2107 18.2097 8.79889 +504 2 13.0094 0.611642 10.1232 12.3896 24.8189 4.81349 +505 1 10.4214 9.73086 12.5154 -11.4047 -1.1898 4.78042 +506 2 11.1516 9.87418 13.1364 2.96428 -4.00819 -1.03044 +507 2 10.2474 8.77319 12.4992 9.30457 6.64045 -3.3636 +508 1 0.651598 2.68478 7.18172 -17.9134 21.5061 -11.8097 +509 2 0.347525 3.6016 7.34273 5.69642 -14.867 -2.54197 +510 2 0.849668 2.34638 8.05251 8.91351 -8.30419 8.52406 +511 1 0.318497 15.272 6.90444 -3.43175 -0.902574 -18.2314 +512 2 0.478582 15.5644 7.78858 6.40513 2.68345 23.4663 +513 2 0.623162 14.3599 6.89897 0.272636 -4.92753 -7.69196 +514 1 17.0533 6.94572 15.0273 7.81631 0.565766 -0.894277 +515 2 17.8128 7.55845 14.958 -6.36521 -5.11302 -0.197876 +516 2 17.4132 6.11744 15.3876 -1.58799 4.21551 0.905627 +517 1 9.15046 12.5368 8.00027 -36.358 14.0028 8.44058 +518 2 9.59383 11.9142 7.43445 3.21629 -19.4527 -15.2125 +519 2 8.22229 12.648 7.66907 25.8785 -7.47424 5.38289 +520 1 1.16102 1.67919 2.79298 -14.264 -19.5534 -4.4961 +521 2 1.06769 2.21394 1.99483 -1.93616 3.76767 1.09072 +522 2 1.84572 2.00753 3.35812 13.0572 19.5695 8.60311 +523 1 4.13351 15.1441 9.8761 6.18483 -5.86151 -6.61306 +524 2 3.91524 15.1965 8.93344 2.62784 3.42174 0.908977 +525 2 5.03514 14.7702 9.87632 -7.63961 1.62567 3.94135 +526 1 7.3909 2.2738 14.7748 9.28558 9.05007 -9.33433 +527 2 7.12441 1.5503 14.2057 -1.53405 -3.63662 -1.19206 +528 2 7.87829 2.88836 14.1809 -18.0097 -8.54319 17.0088 +529 1 18.3492 14.5565 2.15246 12.0934 24.362 7.12212 +530 2 0.551729 14.8667 2.53499 -6.69921 -6.84856 -6.85574 +531 2 17.7888 15.364 2.12839 1.3753 -15.6354 -3.85708 +532 1 10.0163 2.6808 12.9164 -0.493731 -5.11601 -9.40492 +533 2 9.92018 2.0572 12.1601 0.76191 10.4011 8.73608 +534 2 9.26265 3.29452 12.869 4.65507 -2.10266 -3.09911 +535 1 2.95427 8.9021 13.1034 24.5728 -3.04867 -5.91166 +536 2 3.51177 9.68096 12.817 -20.8286 -16.9148 9.19061 +537 2 3.59809 8.18481 13.2917 -7.73525 14.463 -2.49767 +538 1 3.26448 8.6069 3.78485 -10.2248 -21.121 34.5648 +539 2 3.76672 9.19042 3.24166 13.0731 20.305 -12.8555 +540 2 3.48359 8.83627 4.72374 -5.93153 -5.30867 -25.3462 +541 1 5.8473 7.24819 8.6208 2.3932 7.90906 9.86277 +542 2 5.81432 6.28497 8.53212 -5.5277 -2.57364 -0.635967 +543 2 5.0659 7.54439 9.12071 1.08185 -7.49096 -4.29671 +544 1 14.8764 1.57981 1.83846 12.2497 10.4795 -14.7641 +545 2 15.1104 2.2908 2.43504 -9.02026 1.90223 13.0204 +546 2 15.3525 1.8445 1.03212 -8.04537 -15.132 5.23431 +547 1 8.61698 15.0264 0.696156 7.89205 -2.64916 2.43147 +548 2 9.41092 14.8348 1.25307 -18.4618 8.30064 -5.38467 +549 2 7.89576 14.464 1.0316 3.03152 0.23278 2.41128 +550 1 15.4513 1.4301 7.20503 6.99627 -6.82188 0.69389 +551 2 14.8244 0.90582 6.69357 -2.8394 0.789398 0.0418873 +552 2 15.0149 2.26607 7.38205 -7.95005 6.31947 4.24803 +553 1 4.96675 12.927 18.445 -0.392058 -1.0762 11.0005 +554 2 5.34886 12.9244 0.695922 -4.30965 1.19363 -4.30526 +555 2 5.68 13.266 17.9034 2.74534 3.65082 -4.88489 +556 1 15.3953 8.66034 18.0902 -2.07624 -16.7815 -3.18775 +557 2 15.9144 9.19311 17.4724 -5.66293 4.97787 2.21077 +558 2 15.1583 9.22886 0.188985 2.48846 7.45062 3.31632 +559 1 12.0359 3.11648 18.28 -8.04977 7.84102 -5.19135 +560 2 12.2901 3.11968 0.565205 5.43673 -10.4163 -2.44039 +561 2 12.4787 2.41139 17.7764 2.20222 0.638625 8.9068 +562 1 13.1884 12.6911 5.14611 -2.25763 -6.31837 -0.123489 +563 2 13.4652 11.7849 4.90596 3.78769 10.9202 3.38983 +564 2 13.3386 12.7839 6.10454 1.74722 -2.69816 -5.37077 +565 1 6.12211 7.19464 0.152335 -0.889801 -16.5081 12.3486 +566 2 6.2475 8.12337 19.0248 -9.08967 1.02729 -5.81202 +567 2 5.35557 6.85974 0.666933 3.80599 9.00251 -10.0268 +568 1 17.6814 15.8746 14.896 -32.95 0.345881 -9.96463 +569 2 16.7135 15.9334 14.9982 15.4899 6.1636 11.5551 +570 2 17.7111 15.6936 13.9484 19.9419 -0.275145 -3.25111 +571 1 13.1284 0.88699 16.7751 -4.95458 6.20661 5.10718 +572 2 14.0638 0.660956 16.7688 7.30918 -0.228866 0.981928 +573 2 12.6898 18.6827 16.6682 -2.70263 -7.7996 -4.366 +574 1 10.8711 14.4993 7.46323 15.7126 -17.3597 -1.2585 +575 2 10.128 14.0173 7.85917 4.58757 6.56369 -3.56814 +576 2 11.6082 13.8461 7.48059 -10.4237 16.2655 0.791757 +577 1 17.6751 8.40087 2.13849 -13.7675 10.6042 3.42109 +578 2 16.7708 8.37025 2.51335 11.2555 0.423493 -3.0905 +579 2 17.6147 7.881 1.33167 1.95975 -7.58305 -2.5048 +580 1 12.424 7.82566 2.03348 6.80204 18.2298 -3.36389 +581 2 12.2928 8.74872 1.74157 -3.31877 -9.32949 5.70746 +582 2 11.9673 7.27395 1.39444 0.405274 -3.29714 -11.9602 +583 1 12.0088 14.6056 10.3972 49.4943 -15.6831 -19.0447 +584 2 12.4654 14.316 9.56616 -19.1829 7.51475 23.0356 +585 2 11.0956 14.6861 10.1978 -35.275 4.57666 -6.07844 +586 1 6.81054 6.90501 15.534 -24.6279 -1.31201 9.93627 +587 2 7.70831 7.14913 15.3109 11.0416 1.99651 0.427612 +588 2 6.48555 7.50951 16.2192 7.91049 -4.43387 -1.91407 +589 1 7.94039 4.47545 13.2332 14.4982 34.8647 21.806 +590 2 7.26408 4.6474 12.5684 -6.44209 3.92223 0.968251 +591 2 8.05746 5.34482 13.7439 -3.25809 -36.365 -21.9094 +592 1 13.3499 12.2014 14.3127 -1.24116 1.37617 13.1465 +593 2 13.3241 11.2332 14.3368 -6.04942 0.470969 -4.28371 +594 2 13.6308 12.4336 13.4212 3.90264 0.498209 -3.09495 +595 1 14.5954 9.45997 7.28998 13.2192 -1.86441 -1.0042 +596 2 15.4197 9.90762 7.5754 -11.2574 0.0534663 -4.99205 +597 2 13.8535 9.8793 7.72336 -3.17401 5.05716 8.17378 +598 1 12.6619 16.8656 3.26711 -0.0867316 -13.7478 -1.21165 +599 2 12.9036 17.3981 4.01825 1.80146 10.547 8.89773 +600 2 12.7645 17.4143 2.493 -0.0316456 12.4477 -7.66427 +601 1 1.00141 7.10091 17.3455 15.3286 -2.27437 -0.63111 +602 2 0.197357 6.73674 17.6796 -23.7065 -4.2556 16.6559 +603 2 0.696205 7.72166 16.6912 7.12828 11.4292 -16.7267 +604 1 12.984 4.84784 15.752 -30.1278 -7.6986 -1.85236 +605 2 13.773 4.32613 15.627 12.1969 -0.534485 4.03194 +606 2 13.2127 5.76882 15.785 16.3015 19.3583 1.60965 +607 1 2.35806 3.40155 5.13736 7.00458 -19.3644 -43.6846 +608 2 1.86996 2.9687 5.81855 -13.4119 -5.52905 24.958 +609 2 2.73401 4.18924 5.49805 8.9837 23.3098 13.0491 +610 1 8.19273 10.9521 13.6844 -8.81681 4.64201 23.2716 +611 2 8.19092 10.7627 14.6526 -0.424045 0.881441 -21.4162 +612 2 8.95149 10.4932 13.3231 15.2004 -1.23984 -4.72202 +613 1 13.0449 1.52469 13.2577 -17.2068 8.30684 11.3152 +614 2 13.5293 1.59874 12.4201 -3.55841 -0.219514 3.90721 +615 2 12.4208 2.28784 13.3343 18.9425 -17.4385 -9.09999 +616 1 6.61166 13.6023 2.12464 -9.14589 11.0627 -26.7302 +617 2 6.03511 14.0379 2.75872 -4.67031 1.02227 7.02539 +618 2 7.1693 13.0213 2.62577 8.97168 -8.12604 14.3361 +619 1 15.8326 6.37868 12.5447 13.0084 18.5244 20.7727 +620 2 16.3675 6.96965 11.9727 -5.6566 -10.5049 5.53461 +621 2 16.1589 6.56267 13.4684 -3.25982 -7.33208 -24.589 +622 1 16.7829 0.679169 9.53725 3.65315 -1.00951 10.2573 +623 2 16.653 18.4141 9.83094 1.34292 -7.75704 2.15353 +624 2 16.269 0.772043 8.73148 -3.87084 4.41009 -12.8197 +625 1 6.12871 11.643 8.2509 28.8456 37.0564 -10.7514 +626 2 5.32101 11.4251 8.67159 -25.2961 -16.2243 16.4685 +627 2 6.59615 10.8374 8.068 1.48557 -20.4229 -4.39625 +628 1 2.81588 8.6455 0.385911 -12.1168 -14.4708 -15.8933 +629 2 2.2408 8.27575 18.315 12.5525 5.70225 18.3425 +630 2 2.25296 9.2478 0.88122 -2.81952 5.7616 1.15354 +631 1 10.1112 10.3249 6.56463 -6.88185 10.2676 4.3595 +632 2 10.6724 9.72741 7.0699 2.3169 -7.24343 0.885556 +633 2 10.4905 10.3984 5.68005 1.7842 -2.70629 0.197339 +634 1 6.85117 15.7741 6.71172 -4.51814 -4.38518 8.0947 +635 2 7.10947 16.276 7.50071 -0.280141 -2.70051 -1.05147 +636 2 7.0022 16.3747 5.97143 2.95927 2.8361 -5.64101 +637 1 6.55245 12.8624 5.85582 3.66478 4.31955 2.99752 +638 2 6.71899 13.7301 6.24424 -0.933807 5.79026 -3.46681 +639 2 6.12481 12.3549 6.55179 0.263982 -0.200358 2.15574 +640 1 16.7435 12.5401 9.7846 -13.9618 -8.21713 16.7649 +641 2 16.8388 11.8663 9.10427 2.99064 0.578166 -4.74348 +642 2 17.1608 13.3339 9.48085 7.01955 11.3182 -8.14386 +643 1 6.27773 2.82725 2.7475 -16.1332 4.52919 -16.5002 +644 2 6.37029 3.76301 2.48637 6.52487 -6.75351 6.59876 +645 2 5.7241 2.45518 2.0296 8.37538 -0.331655 9.00677 +646 1 10.7419 2.97566 3.2545 -3.93098 2.36946 -8.35386 +647 2 10.3631 3.83794 3.45313 -5.44824 -1.84651 0.91029 +648 2 10.2755 2.65841 2.45654 4.06882 -1.04864 5.83378 +ITEM: TIMESTEP +90 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.80968 6.6261 17.8375 -14.5778 0.995444 8.41947 +2 2 7.95772 6.60642 18.3334 15.3437 1.8775 -14.2431 +3 2 8.74654 5.99095 17.1112 1.57504 -1.57025 6.7209 +4 1 0.142832 8.36014 6.73441 10.0116 -15.4349 27.0014 +5 2 0.232649 8.20449 5.79462 4.11725 -7.32768 -11.6468 +6 2 0.67494 7.65251 7.20998 -18.6261 25.5606 -16.1468 +7 1 8.65703 0.380136 6.98192 16.3005 -1.0776 2.50655 +8 2 9.57515 0.309779 6.66722 -10.0942 0.994659 4.05519 +9 2 8.27212 1.03395 6.395 -6.58679 0.322126 -3.42087 +10 1 6.47941 1.69165 11.7468 2.00503 -21.4393 -6.03474 +11 2 5.9725 2.29393 12.2744 -13.1143 10.2157 7.12378 +12 2 5.89376 0.920881 11.5936 7.71629 6.15291 -2.33076 +13 1 6.9103 5.50063 2.38437 -35.7814 23.4203 2.69428 +14 2 6.20944 5.92743 2.96221 29.3961 -15.7919 -7.47581 +15 2 6.73166 5.94071 1.53167 10.6635 -7.16691 8.95661 +16 1 16.211 10.2361 16.1124 -22.7966 -2.93172 13.0323 +17 2 16.937 10.2632 15.5246 28.6916 5.0146 -15.8412 +18 2 15.9737 11.152 16.3021 -3.36115 -0.429235 -4.16748 +19 1 10.8196 14.9788 2.33309 -6.31813 -9.42536 4.48609 +20 2 10.7437 14.525 3.19227 -2.25161 -0.175376 -6.3843 +21 2 11.168 15.8375 2.56675 6.6431 8.63317 3.56201 +22 1 17.1655 8.21466 10.9616 20.3007 -11.9207 -19.649 +23 2 16.6876 8.89778 11.4174 -14.8371 14.2918 8.905 +24 2 17.9353 8.67496 10.5709 -5.82559 -3.7293 4.59063 +25 1 14.5981 15.9748 16.3536 13.4587 -18.0704 19.8012 +26 2 13.6875 16.2688 16.3636 -10.2246 8.72504 -7.33216 +27 2 14.6733 15.4751 17.2031 2.63957 5.2712 -15.5493 +28 1 12.1292 13.2811 0.580093 14.6523 -12.0599 13.1814 +29 2 11.875 13.3883 18.3092 -10.372 6.98394 -12.7652 +30 2 11.639 13.8901 1.1449 -2.74566 6.59249 -3.74219 +31 1 9.34925 5.48981 3.82539 12.3818 -0.191077 28.8485 +32 2 8.80634 5.44704 4.61652 7.17551 -1.92534 15.5524 +33 2 8.65833 5.42982 3.20736 -26.4153 -0.989629 -43.3837 +34 1 1.57757 3.9189 11.5719 -21.368 33.8782 -18.8992 +35 2 1.50486 4.82423 11.9434 2.77 -7.29772 -4.79385 +36 2 1.95891 3.38097 12.2317 20.2106 -22.0339 29.781 +37 1 2.11583 6.92705 8.12278 -10.2704 -2.23476 -15.4196 +38 2 2.47676 7.42607 8.85663 6.65774 -1.70501 8.2798 +39 2 2.06913 5.99576 8.38149 2.03129 -2.32531 8.57063 +40 1 5.2846 4.43559 7.83749 -11.1092 26.0267 -7.92074 +41 2 5.42959 3.50305 7.74019 3.58921 -20.4287 3.63869 +42 2 4.59753 4.67739 7.1831 9.16507 -0.464339 6.41033 +43 1 3.36483 2.87842 17.4354 -5.48754 -0.0293267 11.8999 +44 2 4.0122 3.13798 16.7945 16.5223 13.9802 -16.1706 +45 2 2.91387 3.69111 17.7275 -1.08839 -5.27878 2.29607 +46 1 7.51128 5.54904 6.16479 9.71808 2.6671 3.00483 +47 2 8.12131 6.08033 6.71556 -9.69992 -1.44216 -4.10694 +48 2 7.04033 4.98631 6.78947 -1.48399 -2.17988 -0.0590646 +49 1 9.79239 7.0023 12.0333 -12.7203 -1.67256 -9.54047 +50 2 10.0574 6.1295 11.7028 -2.54946 7.94968 0.438659 +51 2 9.0334 7.28866 11.4661 15.1177 -5.87574 8.09476 +52 1 14.1269 3.84395 8.13857 -24.8841 12.3935 -19.8999 +53 2 13.4363 4.47719 7.80064 24.2741 -16.3277 6.83338 +54 2 14.3749 4.15432 9.00462 4.04893 6.4318 14.0535 +55 1 4.52686 17.2232 3.85531 -7.09571 -9.71268 16.0786 +56 2 5.35353 17.6803 4.02689 3.89364 6.28665 -2.88462 +57 2 3.96567 17.7155 3.24673 4.45666 4.6431 -9.26961 +58 1 16.1958 16.5107 10.5377 18.4287 -13.9772 -31.1199 +59 2 15.4454 16.6557 11.0933 -16.6117 1.05393 13.9092 +60 2 15.8645 15.9242 9.81336 4.55855 15.7974 16.2758 +61 1 1.967 4.85121 0.0645769 9.40837 -19.0171 0.778776 +62 2 2.73793 5.10942 0.56616 3.15966 4.76786 17.0447 +63 2 1.80075 5.61055 18.1709 -12.801 18.3624 -15.2179 +64 1 11.1737 13.314 16.4367 2.74473 1.78814 5.72217 +65 2 10.7128 12.4641 16.5748 8.32361 2.87799 -7.58216 +66 2 11.8417 13.1969 15.7431 -5.18043 -7.14508 -0.417807 +67 1 10.0458 10.8999 16.8205 33.4394 -5.51473 9.19041 +68 2 10.5428 10.0531 16.9406 -15.1708 22.1127 -3.77119 +69 2 9.12902 10.6892 16.7607 -22.7906 -6.8787 -3.44008 +70 1 11.889 17.5084 13.4814 3.48745 6.24304 -13.0003 +71 2 12.5913 17.1622 12.8998 -9.91022 -4.16273 6.93206 +72 2 12.0139 18.4633 13.4204 2.43964 2.21886 2.73389 +73 1 6.44228 9.49569 12.2996 9.71147 -12.8692 -34.1322 +74 2 7.06965 9.17025 11.5988 -17.7592 6.4035 17.1392 +75 2 6.97144 10.0526 12.8659 4.91959 6.23922 4.73193 +76 1 16.3022 12.832 2.75135 -12.5209 9.65366 -4.24277 +77 2 17.1598 13.1655 2.44684 -4.70434 0.462679 5.46936 +78 2 15.6996 13.6248 2.74248 12.9928 -20.5688 3.1232 +79 1 0.706696 12.7395 5.83755 -10.6776 2.47735 15.1944 +80 2 1.02688 12.9731 4.95908 -4.07327 -10.4263 -9.29508 +81 2 18.3891 12.5308 5.80039 14.5368 6.4085 -10.1514 +82 1 5.29875 16.3254 18.4501 12.7507 -5.44046 -6.67673 +83 2 5.72604 15.6129 17.9385 -8.69196 7.59677 5.8406 +84 2 6.01274 16.6418 0.375909 -8.3334 1.51688 4.30584 +85 1 0.743878 7.68205 4.10167 -26.7478 -30.2572 33.4946 +86 2 0.179417 7.92019 3.37827 -7.5716 9.21403 -16.4097 +87 2 1.60385 7.98113 3.89879 36.269 17.899 -12.2731 +88 1 3.22103 9.09598 6.53924 -28.7289 15.6764 -27.4701 +89 2 3.63534 8.61301 7.2251 9.03881 -15.9481 23.3571 +90 2 2.25678 8.88215 6.53178 21.3431 5.76786 5.41461 +91 1 7.2773 10.3926 16.241 -1.60955 -9.9776 11.4431 +92 2 6.63502 11.108 16.2935 -0.090439 -0.440245 3.15105 +93 2 7.09074 9.80627 16.9963 -3.87073 10.8392 -3.46734 +94 1 11.0095 0.891279 5.03438 2.23591 -17.8064 16.3849 +95 2 10.8775 1.7336 4.57918 5.69275 -3.07397 -7.72854 +96 2 10.7003 0.188666 4.43596 -0.931337 13.9517 -3.17827 +97 1 4.21583 2.94335 13.1635 9.62289 2.41259 16.4284 +98 2 4.47922 3.3428 14.0131 -5.18172 -0.255184 -10.0037 +99 2 4.1364 2.00091 13.3783 -2.2119 -1.88246 -4.82143 +100 1 8.45625 10.2801 1.81127 9.01648 -22.0588 9.24648 +101 2 8.30671 10.8697 2.54783 -2.77767 16.2884 7.52121 +102 2 8.66335 9.4444 2.27657 -0.852681 8.00384 -10.6723 +103 1 10.2261 1.659 15.4538 -6.06042 8.31352 -11.6288 +104 2 11.1361 1.48308 15.6359 20.1952 -3.56794 7.64131 +105 2 10.2187 1.98601 14.5369 -5.79366 -2.30068 5.3707 +106 1 2.60435 12.742 7.94637 -6.15341 0.568057 0.983218 +107 2 3.03975 13.5699 7.72118 6.64853 3.0435 -2.79803 +108 2 1.95513 12.6117 7.24141 1.86204 -3.09485 1.26562 +109 1 3.88579 11.7956 5.01149 -19.6155 -13.0634 1.96641 +110 2 3.74363 11.1082 5.69355 0.727972 11.568 -8.07528 +111 2 3.05901 11.8342 4.47209 17.5209 1.69759 11.0979 +112 1 6.76239 14.55 16.9383 -0.403452 -2.75277 4.08609 +113 2 7.61561 14.9826 17.0312 2.52456 -1.29817 -0.221044 +114 2 6.44911 14.7692 16.0549 2.09428 -3.60588 -3.74869 +115 1 14.1942 14.5231 3.16652 -5.12336 -14.4242 4.12891 +116 2 13.6899 15.3256 3.31261 0.149267 9.23779 -5.23449 +117 2 13.7696 13.8761 3.7521 4.09464 2.97302 0.255936 +118 1 8.7401 18.0877 16.1157 -15.0544 -15.1521 5.72203 +119 2 9.42706 17.4939 16.3945 -6.08837 -23.732 7.70311 +120 2 9.27218 0.11536 15.7481 8.35971 40.209 -14.9349 +121 1 4.63391 1.71898 4.89 36.0507 -5.82478 -13.0459 +122 2 3.81997 2.19927 4.85319 -16.3674 13.8452 0.00946397 +123 2 5.20292 2.04685 4.14723 -16.8402 -3.94878 19.5369 +124 1 15.0105 12.65 16.5031 22.0082 2.89039 39.0948 +125 2 14.6032 12.5883 17.4132 0.919275 4.87615 -33.2046 +126 2 14.3966 12.5461 15.7793 -22.8851 -3.84554 -8.75239 +127 1 15.7197 18.424 16.8504 13.0838 27.0964 8.25258 +128 2 16.3964 18.519 17.5419 -1.36847 2.51381 -4.544 +129 2 15.6686 17.4972 16.714 -13.5977 -31.6712 -2.03374 +130 1 1.39308 1.32386 16.6798 -9.07755 4.26299 3.83254 +131 2 2.19455 1.8573 16.8358 -13.1892 -10.0845 0.867767 +132 2 0.760663 1.62622 17.366 11.6728 -4.82483 -8.86289 +133 1 18.2416 4.3099 15.966 -4.36834 -5.16176 -14.6355 +134 2 17.7783 3.61219 15.465 8.57404 10.6893 6.25867 +135 2 0.425079 4.50442 15.5034 -5.04787 -4.14191 4.79432 +136 1 12.0688 17.0582 16.1192 -6.60497 -5.44285 54.7429 +137 2 11.374 16.6436 16.7154 18.2098 8.22439 -32.524 +138 2 11.7541 17.1189 15.223 -7.97888 -4.44492 -17.7493 +139 1 16.0987 2.72798 18.2222 -6.94033 2.52412 -3.34156 +140 2 15.6657 3.49187 18.6187 5.88163 2.98889 4.51464 +141 2 15.8079 2.8031 17.3159 -2.77048 -8.0731 -14.4365 +142 1 6.58612 13.762 10.0351 1.63352 -0.32404 13.73 +143 2 6.39624 13.3299 10.8846 2.34483 4.77487 -0.634471 +144 2 6.55421 13.0562 9.39028 1.369 -6.64332 -8.7831 +145 1 10.1169 18.5721 2.70869 27.9004 -1.02691 -4.20355 +146 2 10.7561 0.140951 1.98734 -15.1054 -0.137902 13.7961 +147 2 9.28626 18.3596 2.30468 -14.2521 -4.05351 -7.65243 +148 1 3.07988 17.6804 6.1902 -35.1734 2.13391 -17.3705 +149 2 2.15682 17.7525 5.8242 24.0448 -4.32039 20.662 +150 2 3.55195 17.7661 5.36197 20.4585 -2.58277 -0.69289 +151 1 12.6061 16.7775 7.89366 1.16584 -8.73771 -17.6522 +152 2 11.856 16.1922 7.7211 -0.763759 -4.24653 -1.89641 +153 2 12.3057 17.3353 8.59898 -2.13454 17.8975 18.5826 +154 1 14.8965 15.3132 8.35277 -22.4274 15.9599 0.214205 +155 2 14.2421 15.9941 8.02515 16.4945 -20.4059 13.6979 +156 2 15.4898 15.1572 7.61828 5.37632 7.31151 -11.1374 +157 1 17.8957 18.2766 0.201476 9.69326 -17.5267 -0.973127 +158 2 18.6995 17.7195 18.781 -12.0492 3.04369 -7.3597 +159 2 18.2321 0.401263 0.645934 -1.5685 17.2308 6.22008 +160 1 0.802158 10.4818 1.45184 -19.0828 -29.4994 30.4216 +161 2 -0.0309651 10.0246 1.77565 29.2477 9.1244 -14.7118 +162 2 0.53478 11.1455 0.834437 -7.87366 18.9841 -18.3051 +163 1 1.85308 12.2863 3.27351 -7.97315 5.10175 -10.2215 +164 2 1.42551 11.5849 2.74616 7.16023 4.54594 2.45335 +165 2 2.09673 12.9814 2.63054 -3.38314 -5.43944 9.55244 +166 1 0.718881 17.2977 4.9616 -19.2906 6.0419 1.76293 +167 2 -0.10575 17.7685 5.12875 8.39755 13.2462 -10.2288 +168 2 0.622971 16.5645 5.55208 6.7728 -21.2776 10.1703 +169 1 1.03867 0.919889 9.35844 3.74022 -6.32288 33.4729 +170 2 1.10918 0.592533 10.3007 6.31379 11.0803 -22.721 +171 2 0.269914 0.464458 9.03134 -8.6906 -2.38217 -7.04515 +172 1 16.7862 2.42581 13.3986 14.7457 27.0937 -15.311 +173 2 16.9847 2.74906 12.4891 -5.29709 -2.40963 18.2684 +174 2 16.5429 1.52129 13.2791 -8.06021 -27.7395 3.47759 +175 1 2.69738 16.0066 12.0777 13.1506 -14.7233 12.6976 +176 2 3.02715 15.5922 12.9029 -9.51867 9.47826 -13.4594 +177 2 3.28974 15.6737 11.3809 -2.31502 2.53439 -1.78657 +178 1 16.3754 15.4917 6.11201 -7.25585 -20.1131 3.67265 +179 2 17.3156 15.5044 6.29369 9.86882 2.22778 5.36532 +180 2 16.2073 16.2228 5.51797 -0.959992 10.1027 -9.31738 +181 1 5.7174 5.24337 11.7813 4.42707 -14.1004 -1.48072 +182 2 5.44277 5.99707 12.328 1.64183 -4.11158 -2.88134 +183 2 5.22325 4.47043 12.1002 -4.92771 7.03451 -4.06757 +184 1 15.1242 4.92712 0.766674 18.5408 -12.9138 10.3204 +185 2 14.9855 4.62556 1.67944 -3.08744 4.9541 4.0864 +186 2 14.3291 5.35182 0.492873 -21.4444 10.4963 -5.72763 +187 1 16.3798 16.4926 1.83048 25.9496 20.3657 -34.7081 +188 2 16.3432 16.8093 2.72897 -9.33108 7.61853 14.7037 +189 2 16.7914 17.2408 1.28765 -16.0156 -28.1785 20.3541 +190 1 0.157471 4.87182 3.99278 -9.81132 22.7056 -3.03191 +191 2 0.5332 5.76253 4.03054 -8.2904 5.08609 0.673103 +192 2 0.911036 4.31937 4.01308 22.6258 -22.4944 4.73784 +193 1 2.97603 15.0857 15.1688 -3.76699 16.0764 -9.28303 +194 2 2.87698 14.8354 16.0845 -1.20729 -14.2266 12.1787 +195 2 2.48786 15.9266 15.1702 1.40562 1.39337 -6.33902 +196 1 1.10637 14.6846 9.51596 31.8836 22.2572 14.4694 +197 2 2.01065 14.9183 9.89233 -34.4229 -12.9306 -18.6629 +198 2 1.03031 13.7317 9.56194 1.94445 -7.79278 4.16037 +199 1 13.55 16.5172 11.5597 10.1041 14.0808 -3.72584 +200 2 13.3442 17.2549 10.9555 -5.19335 -6.01443 7.16005 +201 2 13.1025 15.7566 11.183 -9.96101 -8.306 -1.961 +202 1 4.75563 1.55237 0.702796 10.3802 -26.0161 11.0265 +203 2 4.32304 2.05314 0.014379 -14.7339 5.42124 -2.63334 +204 2 4.14265 0.839056 1.00315 4.15161 14.819 -1.07901 +205 1 1.52656 18.6416 11.9009 -8.95117 16.8483 13.4998 +206 2 1.43825 0.48402 12.7573 3.56637 -8.71242 -18.201 +207 2 1.98334 17.8196 12.0914 3.68072 -6.34965 2.55122 +208 1 11.4393 10.1383 4.17836 -13.7636 4.05009 -8.78245 +209 2 11.3903 10.5027 3.28707 -1.50281 2.58284 -2.63304 +210 2 12.3655 9.96172 4.28712 17.4192 -2.53267 8.67839 +211 1 8.18359 12.1636 3.86104 -21.222 -14.272 -14.5003 +212 2 9.05859 12.5239 4.0446 -0.40723 6.23371 14.3883 +213 2 7.56046 12.2135 4.62832 23.1203 4.46306 -6.77507 +214 1 14.593 4.04535 3.38111 7.28555 -5.40785 -19.1504 +215 2 15.2127 4.15408 4.10794 5.52844 2.67895 3.03112 +216 2 13.7536 4.35259 3.70606 -13.9578 6.65801 6.31365 +217 1 5.72323 1.65443 7.61073 34.4 15.7962 37.2038 +218 2 5.13785 1.03104 8.01585 -19.7408 -11.9782 7.15973 +219 2 5.42676 1.78462 6.74294 -17.7695 -4.7826 -52.6001 +220 1 17.8873 1.06414 4.83181 6.8154 -0.232455 -4.71432 +221 2 18.4369 1.21178 4.04718 -2.79964 -1.76243 2.38037 +222 2 18.3376 1.55744 5.53048 -5.83965 -0.882229 4.9581 +223 1 6.85055 9.23648 4.54341 6.32277 -8.10519 -4.82585 +224 2 6.75809 9.38079 5.49182 3.88959 4.29486 1.07151 +225 2 7.79379 9.02149 4.39148 -10.7358 1.98669 4.12637 +226 1 2.55801 14.782 2.06648 -8.35029 -12.2797 -25.7867 +227 2 3.24533 14.7191 2.71695 15.3489 0.778658 13.055 +228 2 2.98421 14.5338 1.22242 -9.03529 10.4097 12.3511 +229 1 17.2667 12.9721 13.1114 -20.9369 36.2303 -2.57416 +230 2 16.4188 13.4451 13.3365 18.5804 -22.1292 -0.415694 +231 2 17.7749 13.7311 12.7641 -0.529191 -13.9074 0.965338 +232 1 14.8416 10.5583 1.56689 -2.78575 22.6182 14.2458 +233 2 15.4799 11.2066 1.96334 -16.8252 -10.4846 -9.71145 +234 2 13.9405 10.9259 1.71943 20.5685 -8.6057 -5.43477 +235 1 5.6352 6.7176 4.51351 -9.14706 -11.8638 3.15016 +236 2 6.0003 7.60062 4.53525 2.53301 15.852 -6.04122 +237 2 6.16933 6.24394 5.16122 6.25334 -1.18144 -1.3834 +238 1 8.0084 8.26626 10.2701 -4.49752 14.9075 -15.7864 +239 2 8.53054 8.9292 9.77232 -0.437986 -11.1673 11.0277 +240 2 7.35426 7.95022 9.61336 5.97292 -3.64509 13.4454 +241 1 13.4616 18.4657 5.71166 17.1322 -6.35165 -5.45305 +242 2 12.613 0.202175 5.51075 -18.0122 19.0124 -5.00284 +243 2 13.2587 17.813 6.37409 -3.85709 -10.1746 14.3256 +244 1 0.0252945 2.56986 0.408061 0.439602 -5.22175 -5.84652 +245 2 17.7844 2.56336 0.0359587 -11.4993 -5.28871 3.98864 +246 2 0.277142 3.47535 0.26454 16.627 13.7372 -0.461998 +247 1 12.8639 10.8267 9.72576 -55.6075 31.3565 -11.278 +248 2 11.8723 10.9451 9.72713 30.8534 7.0313 -2.47663 +249 2 12.8724 9.89108 9.83244 20.4971 -22.7651 5.79467 +250 1 0.607625 12.2828 11.1117 24.514 -2.72666 -9.78403 +251 2 18.2964 12.3126 11.1603 -11.5713 5.22338 7.13378 +252 2 1.01642 12.6716 11.9034 -8.98148 -2.79725 -0.830812 +253 1 5.29539 7.3549 13.3064 -7.85772 10.5518 3.63543 +254 2 5.70599 8.16396 12.9287 -0.549664 -12.4206 10.9242 +255 2 5.67568 7.22584 14.1948 2.69835 3.31529 -9.72444 +256 1 1.17555 6.77844 11.9244 -33.9372 -12.3631 -14.3141 +257 2 0.259637 6.99751 11.6106 25.929 -3.06653 9.08527 +258 2 1.58097 7.60434 12.1643 7.59492 14.5493 8.35248 +259 1 15.5141 9.76806 12.4302 -1.8656 17.4266 8.04916 +260 2 15.0855 10.6363 12.2204 12.2826 -22.7347 2.36453 +261 2 16.0019 9.91808 13.2494 -6.58523 -0.731675 -3.13373 +262 1 16.4968 12.5534 5.50851 9.37615 -29.7593 -4.66799 +263 2 16.3074 13.4744 5.68685 -5.44524 15.7433 -9.11055 +264 2 16.3732 12.3531 4.54775 0.322938 17.9758 14.7603 +265 1 6.32376 9.8903 0.169934 -28.7401 -0.365509 -5.18995 +266 2 5.50824 10.2805 0.557378 14.6251 -5.00462 -6.15541 +267 2 7.04833 10.2225 0.694867 12.727 0.898893 11.9262 +268 1 12.1515 6.04661 4.01259 -24.0177 -36.8905 11.864 +269 2 12.231 6.67099 3.30768 1.42994 18.9462 -13.2923 +270 2 11.2548 5.64061 3.89367 21.868 15.3866 4.7403 +271 1 0.316109 12.8908 0.0158726 1.97018 -1.90411 4.82087 +272 2 18.784 13.4984 0.752127 -2.36898 -0.989285 -3.79 +273 2 18.4247 13.2164 17.9164 2.23727 -3.47257 5.47524 +274 1 3.55093 0.0615484 8.6771 30.4928 -5.90286 -4.02028 +275 2 3.49841 18.2151 7.84215 -7.8476 4.22576 -1.41638 +276 2 2.7473 0.557235 8.76228 -21.0031 4.54937 0.225707 +277 1 7.3901 17.5352 4.48573 6.23592 32.7201 -14.6481 +278 2 7.69571 18.4853 4.57976 -11.8279 -33.7706 3.32686 +279 2 7.33788 17.4402 3.51852 2.74261 -6.71083 9.2357 +280 1 9.25 17.16 12.2333 -3.7288 14.5824 3.61249 +281 2 9.26512 16.5009 11.5521 -3.80961 -18.6559 -12.0666 +282 2 10.1634 17.2094 12.5273 3.6148 1.53928 10.2644 +283 1 13.402 13.1082 7.90091 0.220655 -14.9059 29.302 +284 2 13.4302 12.436 8.64233 -5.21958 14.4877 -25.9571 +285 2 13.929 13.8525 8.23076 3.39805 -3.2421 -4.10773 +286 1 14.8025 2.90677 15.4495 23.2091 4.40575 2.70159 +287 2 14.1483 2.29946 15.1328 -14.8482 -16.0174 -4.02081 +288 2 15.4935 2.87296 14.7763 0.208871 3.12507 -3.30872 +289 1 9.90762 15.6519 16.9195 -4.56731 4.54647 -2.1455 +290 2 10.1638 14.7845 16.5964 9.48907 -4.21512 -5.5698 +291 2 9.51082 15.4442 17.7618 -6.39245 0.962418 13.4848 +292 1 11.1953 8.50068 16.6178 -6.68582 -9.72424 -8.69684 +293 2 10.4052 8.01271 16.3331 5.65618 1.52157 -2.37675 +294 2 11.7201 7.85843 17.0918 5.14472 -5.56789 7.7477 +295 1 3.97964 18.2216 16.8609 -11.5365 11.132 -5.80894 +296 2 4.44261 17.5481 17.3724 7.79342 1.98205 9.06349 +297 2 4.16759 0.471834 17.2017 1.31413 -17.4358 -0.663005 +298 1 2.27286 4.25928 8.9046 8.30035 -0.830932 12.3077 +299 2 3.22373 4.0264 8.87035 -15.4899 4.40379 3.11293 +300 2 1.97207 4.14495 9.83591 10.7423 -1.42059 -17.2737 +301 1 9.92348 10.3926 9.8203 -1.21029 -1.85278 -24.2235 +302 2 9.36782 11.1029 9.49607 0.630055 7.16446 -2.16893 +303 2 9.82869 10.3844 10.7566 4.49005 -1.30636 29.4196 +304 1 9.77911 0.915187 10.8241 -1.58049 4.53496 -1.50662 +305 2 9.30516 0.126632 11.1017 -0.152878 -7.87834 6.94802 +306 2 9.15539 1.38664 10.2518 4.51752 0.176684 -4.82426 +307 1 9.1489 15.1729 10.179 6.96198 -6.50551 5.53221 +308 2 8.91001 15.8322 9.53904 -4.06695 15.478 -9.20984 +309 2 8.38415 14.5913 10.1616 -4.75674 -5.76082 4.02117 +310 1 0.743465 9.68917 10.1631 30.9903 9.57445 -5.37239 +311 2 0.884314 10.6156 10.4664 -8.35327 -15.1374 -2.2352 +312 2 1.62506 9.41264 9.82336 -24.2866 3.90606 7.18729 +313 1 17.1113 4.7779 8.02102 2.26389 -23.2748 8.45538 +314 2 16.3418 5.309 8.21811 -5.84575 9.78705 2.38191 +315 2 17.0463 3.99595 8.60382 3.74785 14.695 -9.14029 +316 1 14.847 14.6269 0.171171 -19.7527 -14.4968 -14.2937 +317 2 15.5321 14.9161 0.755334 10.0132 13.2257 15.972 +318 2 14.1228 14.2968 0.729437 5.50655 3.69994 -2.14986 +319 1 3.90456 11.0507 9.5998 -4.69832 -0.998696 -0.0493525 +320 2 3.86255 11.1688 10.552 1.28841 5.10968 9.84865 +321 2 3.27063 11.6917 9.24194 0.0177884 -1.71993 -8.82733 +322 1 11.433 10.7439 1.41897 29.5023 2.97313 10.7876 +323 2 11.6019 11.6536 1.12948 3.85703 -2.03295 -2.25776 +324 2 10.504 10.6413 1.35913 -35.0433 -4.68689 -6.35229 +325 1 13.1835 7.21214 12.6412 -8.23521 -20.1104 -3.47812 +326 2 14.127 7.05932 12.5127 3.33109 -0.638199 4.03042 +327 2 12.8061 6.29857 12.6985 3.22225 19.9882 2.50286 +328 1 9.65928 1.95745 0.843925 10.2182 6.36996 -3.06277 +329 2 8.81763 1.63483 0.51897 -5.65357 2.11518 2.03686 +330 2 10.1334 2.26536 0.0610097 2.29468 0.231167 4.03759 +331 1 10.5974 13.4461 4.57973 -2.39764 -3.17335 8.92217 +332 2 11.4415 12.9723 4.66721 0.170993 3.79528 3.71784 +333 2 10.3828 13.7711 5.47244 5.6647 1.39651 -7.04866 +334 1 14.5805 1.64306 10.9903 3.01891 29.9103 -7.34195 +335 2 15.4206 1.31489 10.661 2.43812 -13.4824 -3.17866 +336 2 14.6923 2.61327 10.8523 -8.77415 -13.7688 6.87151 +337 1 14.4577 12.0498 11.5485 -29.7481 -1.24334 12.4997 +338 2 15.1787 12.3182 10.9897 13.6492 5.38623 -14.4259 +339 2 13.7324 11.7114 10.9784 17.3586 4.51945 3.50834 +340 1 8.16823 5.15587 9.894 -28.9634 21.8059 19.126 +341 2 7.25961 5.26999 10.2972 28.5921 -4.04796 -11.5402 +342 2 8.23961 4.23455 9.67377 -1.01689 -19.4985 -4.69706 +343 1 1.66839 17.0027 18.4477 20.9596 26.331 -27.2012 +344 2 2.19503 17.5247 17.7665 -16.8758 -18.2972 22.1195 +345 2 1.83767 16.0826 18.2308 2.67698 -10.8321 1.22526 +346 1 1.40907 17.4029 15.3161 -1.8056 14.8407 8.29727 +347 2 1.4134 18.2156 15.8633 3.96238 -8.68525 -7.97287 +348 2 0.471831 17.1989 15.2085 1.34275 -7.61847 -1.46046 +349 1 3.49459 5.75594 6.06077 -10.0958 -15.2551 6.44531 +350 2 3.00844 6.4276 6.56158 3.56089 -0.0685925 -1.76679 +351 2 4.03572 6.19023 5.40706 10.0519 13.1926 -8.23224 +352 1 12.6765 9.5142 14.2706 -5.75697 27.7722 -14.2581 +353 2 13.0673 8.79775 13.7668 1.15853 -14.5514 3.26719 +354 2 12.382 9.20431 15.1249 -1.95515 -14.6959 8.85488 +355 1 4.11243 15.2112 7.12768 13.4261 4.57048 -4.21166 +356 2 3.68336 15.9917 6.77855 -13.243 7.84695 -2.74865 +357 2 5.05149 15.4218 6.9541 -4.34911 -9.58911 5.5273 +358 1 0.807347 8.85082 15.1137 12.1653 -16.291 -5.21716 +359 2 0.579225 9.7725 15.0704 -11.1033 15.5539 4.56692 +360 2 1.61112 8.83255 14.5724 -2.7466 -7.45742 -2.63208 +361 1 12.955 8.28126 10.1315 4.47425 -26.4789 2.77461 +362 2 13.6724 7.69661 9.75218 -12.3213 15.4477 18.6624 +363 2 12.7996 8.04439 11.0766 12.5165 -4.13221 -14.8671 +364 1 15.2413 7.99312 3.46307 21.2061 37.6089 -22.4299 +365 2 14.4756 7.7211 2.94477 -5.95544 -17.8301 8.14742 +366 2 15.6187 7.46858 4.17258 -15.9179 -18.0198 8.83427 +367 1 17.1356 6.70525 18.6386 6.47512 25.7091 -12.2215 +368 2 16.6963 5.89525 0.233999 -10.309 -8.75159 3.76643 +369 2 16.4339 7.33237 18.3357 11.2115 -13.3479 10.1501 +370 1 8.91981 7.02641 7.93476 -17.5815 -13.9195 9.00305 +371 2 9.83812 7.25537 7.853 19.0031 7.73693 -0.560136 +372 2 8.849 6.45385 8.72921 -1.20537 6.38433 -11.1549 +373 1 12.4784 0.471427 1.2 -1.5382 -11.3036 2.52426 +374 2 13.1724 0.955828 1.65737 6.96212 2.95671 -0.139484 +375 2 12.8855 0.124586 0.40059 -1.81614 4.12295 -0.743523 +376 1 5.7338 15.0104 14.483 3.21537 -3.99883 -6.81615 +377 2 4.79914 15.0689 14.6899 -13.3072 1.49299 3.3932 +378 2 6.00174 15.8892 14.196 3.10174 7.95604 -0.192962 +379 1 3.73322 6.46389 1.74186 4.97145 -11.2752 -15.478 +380 2 3.41061 7.27444 1.33141 -3.85483 5.16021 2.72417 +381 2 3.71896 6.61791 2.68352 1.01313 6.07651 8.98471 +382 1 3.85612 11.3357 12.3214 9.74989 2.64833 3.1782 +383 2 4.70398 11.747 12.5616 1.03181 -4.89631 -4.08494 +384 2 3.21292 11.8498 12.8111 -10.0411 9.11388 1.93155 +385 1 5.31882 3.86098 15.7247 -14.6622 43.9235 8.42988 +386 2 6.03513 3.29574 15.4808 24.4173 -17.8012 -3.50674 +387 2 5.69837 4.77513 15.8552 -8.87612 -28.0013 -6.19005 +388 1 14.0506 10.0984 4.70507 12.9021 5.9963 -48.2497 +389 2 14.373 9.82203 5.54065 6.42583 -15.3441 32.1568 +390 2 14.6577 9.66966 4.04903 -16.6446 6.96016 16.1133 +391 1 7.63016 17.2999 9.07082 4.88589 -1.83029 4.08955 +392 2 7.05774 17.6443 9.76408 -9.77236 -5.61109 0.722829 +393 2 7.90646 18.0745 8.58282 6.82018 7.73796 -12.3688 +394 1 4.54853 14.4989 3.92298 4.51049 -12.0827 -19.4455 +395 2 4.48676 15.3439 4.34231 1.7531 23.2793 6.06498 +396 2 4.47875 13.8474 4.61218 -0.893081 -14.6097 11.9436 +397 1 14.1162 7.44072 15.859 5.72353 -2.97717 1.52707 +398 2 14.8925 7.45204 15.2793 -3.03398 0.324075 5.79835 +399 2 14.4079 7.84098 16.6936 -1.38652 -1.7593 -3.67135 +400 1 2.91046 18.3824 1.92161 -14.6763 12.8451 -3.99897 +401 2 2.56811 17.7851 1.23066 -1.64793 1.84374 10.7046 +402 2 2.14175 0.293363 2.23042 22.3557 -16.8939 -8.97037 +403 1 8.00583 1.57089 4.46736 31.4122 8.97246 -10.4438 +404 2 7.40416 1.98491 3.8452 -8.42929 2.78546 -1.25861 +405 2 8.8818 1.75969 4.05638 -17.375 -7.71187 12.4181 +406 1 2.50572 14.1939 17.7606 -21.3738 -1.77578 0.320632 +407 2 1.88811 13.4733 18.0291 6.14349 16.4853 -5.08899 +408 2 3.36784 13.821 17.8832 22.941 -11.7322 7.4453 +409 1 0.984409 1.95477 13.9081 14.9076 0.866869 -10.4657 +410 2 1.09683 1.70126 14.8211 1.02253 -2.39927 14.2505 +411 2 18.6933 2.04344 13.7674 -16.8072 2.56857 -0.576968 +412 1 4.29327 0.177122 13.8951 16.4248 3.49785 -13.6548 +413 2 5.17049 18.4046 13.9646 -5.43827 4.9033 -2.01246 +414 2 3.78721 18.4389 14.598 -10.2443 -5.04864 16.3534 +415 1 7.35353 0.990853 18.4538 -34.7507 -7.39683 16.7648 +416 2 7.55815 0.737816 17.5561 -3.16307 -6.20953 -15.156 +417 2 6.35665 0.974064 18.6083 33.4978 7.02218 -7.3799 +418 1 15.8311 18.4256 13.8966 -40.0758 9.01377 -20.0242 +419 2 14.87 18.5763 13.7207 27.6408 -4.60797 -2.68704 +420 2 15.8417 18.2976 14.8321 10.6174 3.57585 21.6768 +421 1 10.2864 4.58419 16.2444 -24.4222 -37.2091 -9.88285 +422 2 11.2299 4.68793 16.3674 13.142 -4.29349 -1.09379 +423 2 10.1171 3.59079 16.124 8.18179 40.05 5.52806 +424 1 15.8917 17.7071 4.46459 -20.0388 -20.4222 2.09772 +425 2 16.4651 18.4471 4.57513 18.3163 24.2221 3.8588 +426 2 15.0409 18.0029 4.83395 4.42355 -1.752 -6.47073 +427 1 6.88773 17.6166 13.9821 -38.4037 0.167583 13.1844 +428 2 7.46394 17.6315 14.7417 15.8748 3.42447 12.5511 +429 2 7.41699 17.4009 13.2391 27.9809 -3.71977 -23.5355 +430 1 13.1764 6.43911 6.52144 -5.83912 -0.258919 -12.4557 +431 2 14.0695 6.77261 6.34605 -1.47407 -3.35023 -0.470203 +432 2 12.7466 6.3372 5.63472 11.513 2.45032 19.1456 +433 1 7.86196 2.29978 9.4638 -2.97627 -2.7765 -21.1046 +434 2 7.31086 2.09746 10.2267 -8.88065 1.6173 3.7395 +435 2 7.37564 1.98398 8.66115 7.69705 6.95472 18.2428 +436 1 15.1916 14.7366 13.8236 -12.2847 5.72199 -1.13466 +437 2 14.8954 15.0381 14.6996 2.36081 -1.57038 -3.3629 +438 2 14.579 15.1371 13.1848 7.3504 -2.29354 4.97967 +439 1 9.39483 8.42303 3.86324 -21.5436 -11.8424 -10.9865 +440 2 10.2164 8.84977 4.07537 16.3384 7.87643 5.27894 +441 2 9.57157 7.47345 3.83359 1.44741 0.673327 1.03302 +442 1 17.655 13.5671 16.4489 -7.58846 13.4511 -15.7424 +443 2 16.7203 13.3469 16.3992 -7.59268 -4.18946 5.70215 +444 2 17.688 14.4057 15.9472 10.2114 -8.11811 3.61388 +445 1 4.94979 10.486 2.86622 25.3355 -10.7625 -10.0508 +446 2 5.84023 10.0991 3.03563 -22.0316 6.96347 2.01482 +447 2 4.71704 10.9487 3.67532 0.603793 8.46932 2.75775 +448 1 3.68042 8.39717 9.8747 -7.87972 -17.3414 17.5888 +449 2 3.759 9.34077 9.71499 3.24219 9.53521 -0.886609 +450 2 3.55014 8.28216 10.8428 3.92085 5.02512 -16.6805 +451 1 15.9973 6.92061 5.87772 4.82031 -5.03924 3.59177 +452 2 16.6812 7.41263 6.34454 2.21588 0.961055 0.440265 +453 2 16.3186 6.0008 5.83915 -7.41322 12.2727 -5.03736 +454 1 15.3004 7.2666 8.94213 -32.1238 -12.1179 -31.7334 +455 2 15.9839 7.55437 9.51768 24.5834 17.5628 17.3411 +456 2 15.1488 7.91682 8.21973 7.72693 -8.10504 16.1569 +457 1 6.21705 12.8062 12.747 -22.7002 13.2796 -10.093 +458 2 7.05571 12.494 13.0465 21.6431 -16.5072 9.89045 +459 2 6.01919 13.5682 13.3077 2.09027 1.41895 1.21426 +460 1 12.1299 4.57596 13.1432 22.4432 17.9492 20.1123 +461 2 12.1793 4.58175 14.1216 4.56317 3.76233 -12.2652 +462 2 11.3861 4.04706 12.9369 -26.6961 -18.2025 -7.73732 +463 1 11.4375 8.07047 7.90979 27.6542 -15.5792 16.7856 +464 2 12.1952 7.52933 7.56059 -23.0528 10.899 -6.13628 +465 2 11.6627 8.11033 8.86659 -7.72222 6.32108 -19.0792 +466 1 16.9453 10.7968 7.63148 -3.5821 -10.5143 21.6719 +467 2 17.6495 10.1525 7.46889 2.86773 -0.504685 -4.5375 +468 2 16.8108 11.3218 6.85057 1.29813 10.4979 -20.4226 +469 1 5.19425 18.0282 10.6847 0.056878 3.62778 8.77145 +470 2 4.66571 17.4143 11.2104 4.95394 3.09506 -2.12913 +471 2 4.57063 18.3664 10.0251 3.33377 -5.62986 -0.929046 +472 1 7.60987 17.4226 1.56636 -8.76834 11.2024 10.6057 +473 2 8.12097 16.6429 1.35059 3.07922 -5.96866 -14.3061 +474 2 7.62904 18.066 0.842261 4.5937 -2.56699 -0.219584 +475 1 1.93734 12.9421 13.6328 4.51097 2.01356 -10.2989 +476 2 1.33249 12.4003 14.1383 -4.04092 -5.16916 8.28012 +477 2 2.1441 13.7105 14.1828 3.43289 -0.0153047 1.69165 +478 1 9.36109 6.77295 14.8254 28.0404 -16.4025 -23.0383 +479 2 9.79586 5.92856 15.0909 -10.7826 13.1246 6.51236 +480 2 9.73683 6.91972 13.9197 -17.1545 2.79671 17.5547 +481 1 15.2759 4.38629 10.7467 0.911226 -10.0818 1.35121 +482 2 16.2063 4.08729 10.7712 -9.28003 7.88291 1.38983 +483 2 15.15 4.95989 11.5268 6.34994 -5.62458 -10.0329 +484 1 11.4488 6.21672 0.0274361 8.35139 15.4334 1.07365 +485 2 11.547 5.26836 -0.0918922 -6.12153 -5.65013 -4.62095 +486 2 10.5221 6.46299 18.5238 -1.7877 -10.3718 -2.04901 +487 1 18.4903 11.4194 14.9121 8.77287 -18.4144 -27.074 +488 2 18.1021 11.8559 14.1353 -5.2902 0.217957 4.39134 +489 2 18.3331 12.0271 15.6113 -5.23497 22.6985 22.6894 +490 1 7.12593 9.28496 7.31024 -23.9992 -6.07508 6.39318 +491 2 6.74279 8.45494 7.66169 4.89732 10.9664 -5.80838 +492 2 8.06011 9.1434 7.29118 23.2007 -3.69072 -2.70719 +493 1 18.3302 15.3588 12.1663 1.84912 0.0598217 5.47138 +494 2 0.628985 15.4631 11.9685 -1.01298 4.74778 -2.81479 +495 2 17.8359 15.8974 11.5264 -1.18931 -3.22386 -0.556154 +496 1 16.5345 4.36456 5.22425 -62.6276 -15.6665 42.2949 +497 2 16.4135 4.0372 6.15475 14.4043 4.47956 -24.0603 +498 2 17.4334 4.499 5.03806 48.2264 1.34274 -11.6623 +499 1 17.733 3.12037 10.7685 2.78093 13.2032 15.2159 +500 2 18.62 3.27348 11.1411 -3.87004 4.46435 -8.2182 +501 2 17.7411 2.21797 10.4818 -1.03268 -21.1847 -12.2715 +502 1 12.2988 18.6545 10.1426 21.4258 -12.4002 -10.8053 +503 2 11.5002 0.459945 10.3706 -28.4452 4.23152 6.39845 +504 2 12.9389 0.72089 10.1511 12.8533 4.08749 0.539844 +505 1 10.4313 9.72872 12.541 3.98701 -3.38274 8.58973 +506 2 11.1703 9.84044 13.1623 -1.01011 3.74187 -3.45859 +507 2 10.4039 8.77038 12.4204 -3.66163 0.188688 -4.07709 +508 1 0.615048 2.63664 7.2276 -9.26807 24.3162 -18.5585 +509 2 0.353188 3.56967 7.37092 2.19049 -16.4853 1.00686 +510 2 0.949026 2.32684 8.06684 4.15829 -4.72879 9.31366 +511 1 0.333537 15.2707 6.93805 -1.63763 -14.4268 -44.2284 +512 2 0.559673 15.3175 7.85021 9.94673 -3.51892 30.6084 +513 2 0.629693 14.3791 6.62643 -7.55161 17.6489 9.10591 +514 1 17.0527 6.91364 14.9743 11.0217 0.359412 -1.38417 +515 2 17.7989 7.54943 14.9113 -7.11537 -10.2599 3.19545 +516 2 17.3979 6.08953 15.3732 -1.90278 10.2985 -1.25317 +517 1 9.14167 12.5321 7.98456 -51.8007 8.58975 -7.36144 +518 2 9.48882 11.7504 7.57305 13.8522 -18.8219 -15.7166 +519 2 8.22261 12.6161 7.58551 34.0094 -0.937982 16.6367 +520 1 1.15656 1.63828 2.76743 -9.76481 2.77041 -4.10292 +521 2 0.864287 2.18836 2.03128 -7.19413 -5.97378 -5.55322 +522 2 1.70002 2.22125 3.28253 11.7483 7.29404 14.7886 +523 1 4.17339 15.1305 9.84913 -14.3711 5.0779 2.99988 +524 2 3.91961 15.3463 8.93389 10.9385 -4.50851 5.90843 +525 2 5.03476 14.6902 9.78793 -0.575875 2.49321 0.528438 +526 1 7.3951 2.27992 14.8377 -1.12966 16.8522 -8.99686 +527 2 7.16414 1.54106 14.2639 1.26623 0.276941 -0.531744 +528 2 7.65338 3.03331 14.2573 -5.05472 -19.0282 8.30824 +529 1 18.3172 14.5403 2.1483 15.3986 5.40572 3.08201 +530 2 0.535799 14.8642 2.50804 -16.0996 -1.12956 -11.071 +531 2 17.7238 15.3001 1.99479 6.48993 -0.927096 4.3539 +532 1 10.0475 2.68059 12.9077 -3.02015 -13.9614 -15.6621 +533 2 9.89167 2.00033 12.2018 7.6523 15.7956 13.7679 +534 2 9.26985 3.25658 12.875 1.66072 1.15674 0.355625 +535 1 2.93978 8.85687 13.107 17.7725 7.3386 -7.69378 +536 2 3.37522 9.71823 12.8547 -12.3312 -24.1388 6.15133 +537 2 3.67473 8.22279 13.2377 -8.38529 8.44125 1.12687 +538 1 3.27106 8.61507 3.79074 -8.49716 -38.7584 59.7131 +539 2 3.66196 9.22584 3.22278 26.3747 36.1018 -32.8858 +540 2 3.70281 8.77413 4.67945 -18.9434 -3.96308 -29.2422 +541 1 5.92777 7.2521 8.64891 -10.8881 -6.62505 3.42768 +542 2 5.84919 6.30478 8.465 1.79189 -1.90292 -1.42585 +543 2 5.07694 7.48175 9.0605 5.83384 2.94932 1.14829 +544 1 14.8827 1.64134 1.82872 -12.6885 -28.1567 -9.76357 +545 2 15.1087 2.39997 2.36476 0.314968 13.4446 -1.58597 +546 2 15.1034 1.73075 0.884031 8.80659 10.9019 15.543 +547 1 8.66156 14.9913 0.655877 15.6167 -4.79217 23.7466 +548 2 9.42437 14.9505 1.28455 -14.0351 0.988592 -13.753 +549 2 7.99981 14.403 1.0655 -3.22335 6.28365 -6.24421 +550 1 15.4067 1.46647 7.20695 -8.82589 -12.8718 -0.882757 +551 2 14.775 0.932663 6.69065 9.74374 4.52972 3.50353 +552 2 14.8641 2.16562 7.57814 -1.0399 11.0322 0.525673 +553 1 4.92475 12.8978 18.4559 2.19674 -3.23744 10.1082 +554 2 5.23586 12.8997 0.738081 -1.33722 2.66651 -10.6279 +555 2 5.70033 13.1343 17.9365 -0.0827318 6.23371 -0.0935372 +556 1 15.3819 8.68528 18.0932 8.72121 10.5448 -14.8557 +557 2 15.8142 9.23534 17.405 -7.78496 -12.8196 8.73029 +558 2 15.2566 9.31777 0.164984 -6.85428 -0.586954 10.5179 +559 1 12.0126 3.13082 18.276 9.47145 -1.72319 12.159 +560 2 12.2482 3.16999 0.564179 -5.55591 0.644277 0.165862 +561 2 12.5655 2.41012 17.9461 -5.90061 -0.236568 -11.7395 +562 1 13.2006 12.6959 5.14014 6.0546 -4.02499 4.06103 +563 2 13.6294 11.8271 5.0147 -6.69767 7.2237 -2.15456 +564 2 13.3727 12.9234 6.07289 -1.67526 -4.52376 -7.3865 +565 1 6.1651 7.14436 0.195504 -22.0894 -12.2339 1.18179 +566 2 6.12052 8.09409 18.9477 10.183 13.9972 -1.43251 +567 2 5.2591 6.87987 0.448218 12.567 -4.05161 -1.41715 +568 1 17.6881 15.878 14.8655 -1.85909 5.77814 22.6605 +569 2 16.7739 16.1608 15.0761 11.3822 -6.39517 -19.8211 +570 2 17.8371 15.675 13.9293 -11.1648 4.64831 -4.02463 +571 1 13.1067 0.88062 16.8301 -1.16362 5.09418 6.26073 +572 2 14.0188 0.56665 16.8428 4.80395 1.33473 -1.08149 +573 2 12.5822 18.7235 16.7479 -0.784604 -6.20947 -5.79489 +574 1 10.8701 14.5014 7.48366 30.6398 4.5327 -13.288 +575 2 10.1924 13.8927 7.76637 -8.27046 -6.89901 6.40521 +576 2 11.688 13.9665 7.40985 -13.0568 5.23738 5.47236 +577 1 17.7216 8.3975 2.13341 -5.03714 18.392 15.6468 +578 2 16.8261 8.35978 2.51012 1.26608 -2.81583 -3.60077 +579 2 17.7343 7.78208 1.41002 -5.68948 -14.3091 -15.2975 +580 1 12.4651 7.83121 2.02849 6.21002 21.8293 -0.701234 +581 2 12.2371 8.77742 1.88873 1.61752 -16.1639 -0.0618129 +582 2 12.1801 7.35781 1.23988 -4.06145 -2.69746 -4.32972 +583 1 11.9912 14.5504 10.3779 26.255 2.08103 -27.6641 +584 2 12.3772 14.5828 9.46952 -12.6474 -4.22617 24.8662 +585 2 11.0517 14.669 10.2537 -15.8484 3.20565 2.09431 +586 1 6.76727 6.87556 15.5462 0.393734 11.8444 22.477 +587 2 7.69535 7.12306 15.3658 -7.56189 -7.86407 -0.973014 +588 2 6.54154 7.32616 16.388 3.13619 -10.9433 -13.6985 +589 1 7.93405 4.43454 13.181 3.70457 37.9343 33.3332 +590 2 7.23909 4.66367 12.5613 -7.79541 1.00974 -8.53955 +591 2 7.95717 5.24214 13.788 5.6586 -32.0049 -23.1645 +592 1 13.3208 12.2124 14.3278 -1.85908 1.78375 8.34338 +593 2 13.1627 11.2597 14.246 -0.36998 0.633125 0.823702 +594 2 13.6236 12.4909 13.4584 3.579 0.31603 -3.71376 +595 1 14.5678 9.48203 7.30395 8.22624 -5.55489 -6.16459 +596 2 15.3274 10.0218 7.53849 6.73854 1.05081 2.13221 +597 2 13.8344 9.86252 7.77014 -14.2105 5.15772 9.40205 +598 1 12.6689 16.8584 3.2838 3.32354 22.4122 -6.02395 +599 2 12.8251 17.4603 4.02708 -0.185303 -8.85949 -0.0347213 +600 2 12.7374 17.4469 2.50984 -1.71014 -6.46341 4.85536 +601 1 0.984375 7.0735 17.3432 34.0501 -3.91376 2.11413 +602 2 0.125246 6.96907 17.7347 -25.3968 2.18392 3.09576 +603 2 0.950307 7.67775 16.5933 -9.77339 5.8232 -4.41721 +604 1 13.0022 4.84407 15.777 5.081 -10.3329 -5.56354 +605 2 13.7485 4.25418 15.5901 -10.0146 -2.33354 7.04552 +606 2 13.4521 5.67804 15.8535 -1.12386 24.7122 1.66863 +607 1 2.36131 3.40053 5.10919 -9.6311 -14.0051 -9.38531 +608 2 1.85776 3.14724 5.88615 -5.89279 -11.6191 4.05299 +609 2 2.64546 4.27356 5.34111 14.5219 19.3293 2.74972 +610 1 8.16093 10.9198 13.7208 -5.48668 -10.5203 36.1407 +611 2 8.01338 10.5218 14.6488 11.4544 18.6016 -43.3573 +612 2 8.9553 10.5154 13.3405 3.89898 -1.19123 3.66799 +613 1 13.0685 1.50992 13.279 -14.1832 25.7313 -25.8855 +614 2 13.6244 1.50815 12.4613 -6.9447 -4.36872 19.5281 +615 2 12.4297 2.25673 13.1075 20.3356 -25.0236 11.2619 +616 1 6.62047 13.6375 2.07221 -5.18984 1.0977 1.00923 +617 2 6.01355 14.0796 2.67998 -4.17105 4.32933 -3.39809 +618 2 7.10668 13.0566 2.65885 8.90022 -6.51269 2.26225 +619 1 15.8066 6.3469 12.5124 13.7748 11.2213 20.1038 +620 2 16.2844 6.87459 11.8544 0.57451 -1.64399 2.92177 +621 2 16.2805 6.52872 13.3684 -12.0243 -5.9969 -18.7155 +622 1 16.7622 0.649503 9.5351 11.3629 -0.534141 16.2257 +623 2 16.8233 18.3334 9.63984 -7.20854 -2.096 2.62458 +624 2 16.3504 0.825019 8.69009 -8.20455 0.909068 -17.3039 +625 1 6.16155 11.6721 8.23727 11.0478 -14.7079 4.32064 +626 2 5.37204 11.4355 8.7099 -18.5694 3.37101 8.66714 +627 2 6.52549 10.7898 8.06052 6.85938 7.24602 -7.48704 +628 1 2.80718 8.60686 0.397493 -27.1124 -12.7057 -15.0387 +629 2 2.16203 8.12721 18.4284 20.3601 19.9434 23.0266 +630 2 2.28863 9.2379 0.937046 1.66532 -5.5958 -10.4069 +631 1 10.1061 10.2794 6.574 -2.68384 6.39054 8.98367 +632 2 10.587 9.61275 7.07222 2.60765 -6.52577 4.24337 +633 2 10.6348 10.4062 5.77746 -5.53346 0.236498 -3.27199 +634 1 6.84319 15.7735 6.74802 2.92919 -7.52667 3.13791 +635 2 7.22287 16.2754 7.48672 -6.2609 -2.86584 0.474311 +636 2 7.16745 16.2182 5.95944 -1.73758 9.59963 -7.48558 +637 1 6.59004 12.8453 5.92771 5.9232 5.70246 -10.7633 +638 2 6.81648 13.7523 6.14266 -3.08056 9.02497 3.95142 +639 2 6.18071 12.4806 6.71128 -2.95494 -1.85994 5.08984 +640 1 16.7187 12.5557 9.81602 -6.97981 -8.42056 3.44329 +641 2 16.7367 11.9049 9.10465 3.04519 -4.31121 0.702836 +642 2 17.0063 13.3635 9.40922 2.88649 12.8114 -1.84814 +643 1 6.30344 2.78963 2.73877 -9.04367 -13.9111 -2.70816 +644 2 6.4136 3.72217 2.50807 2.58545 1.58307 -3.30667 +645 2 5.8765 2.3355 1.98292 3.38351 11.0448 5.4768 +646 1 10.696 2.92954 3.25253 -4.78239 0.546409 -3.48797 +647 2 10.285 3.77274 3.47459 -3.26512 -0.523652 -3.33277 +648 2 10.2907 2.61783 2.41902 1.90367 1.74508 6.25714 +ITEM: TIMESTEP +100 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.7952 6.55188 17.82 -14.0925 -19.7636 -3.75378 +2 2 7.88023 6.44026 18.1695 19.5523 6.07432 -5.80163 +3 2 8.99571 5.7855 17.2401 -2.64216 11.7935 9.74201 +4 1 0.13387 8.39658 6.71777 11.0686 -17.0219 51.8315 +5 2 0.297964 8.15416 5.82611 3.65759 -8.78146 -34.4276 +6 2 0.663997 7.73523 7.26654 -21.1289 27.238 -19.6589 +7 1 8.71966 0.469223 7.04147 6.63626 1.40123 -3.67752 +8 2 9.62406 0.435013 6.6778 -11.0722 1.83914 2.93454 +9 2 8.2146 0.970711 6.38506 4.19741 -2.20649 2.49068 +10 1 6.44826 1.6863 11.7796 22.1018 -16.0737 -10.0998 +11 2 5.81214 2.23354 12.2013 -20.9633 15.3476 12.0772 +12 2 6.02072 0.836228 11.6256 -4.8988 -3.15305 -3.34718 +13 1 6.89097 5.45035 2.38694 -14.0878 18.1315 0.804401 +14 2 6.23022 6.01625 2.92115 27.2653 -21.4077 -23.7527 +15 2 6.91491 5.77412 1.45583 -9.40281 2.39732 25.4334 +16 1 16.2334 10.2315 16.0664 1.22095 -12.8583 -8.35396 +17 2 17.1105 10.2758 15.679 0.521344 2.88453 0.293596 +18 2 15.9464 11.1361 16.1778 -3.48259 10.2735 3.78324 +19 1 10.8573 15.0007 2.35193 -8.17785 -20.274 -7.01899 +20 2 10.8024 14.5151 3.19219 -3.98998 0.859093 -1.88791 +21 2 11.3201 15.8014 2.5578 8.92048 16.4226 10.3474 +22 1 17.1726 8.21805 11.024 14.0848 -19.0512 -23.2094 +23 2 16.691 8.91369 11.4632 -8.36385 12.6057 9.94503 +24 2 17.8921 8.64427 10.518 -5.71892 -0.131476 8.97419 +25 1 14.5956 15.9799 16.3132 20.7515 -13.8502 3.42179 +26 2 13.7469 16.3872 16.1713 -21.6627 3.23661 7.28294 +27 2 14.5521 15.3865 17.0935 -1.40849 8.21009 -3.21798 +28 1 12.1509 13.2395 0.573493 6.57205 3.5904 2.72349 +29 2 11.837 13.3986 18.3303 -3.80405 -1.74926 -15.723 +30 2 11.7012 13.9105 1.09717 -2.12612 0.929616 9.94365 +31 1 9.32377 5.48511 3.80515 37.2224 0.919853 24.8976 +32 2 8.88878 5.295 4.65312 -11.8166 2.00864 -7.28102 +33 2 8.70235 5.44743 3.10202 -35.0307 -2.6733 -15.0358 +34 1 1.53449 3.88906 11.5762 -21.4592 42.8438 -26.3691 +35 2 1.39761 4.77552 11.9865 7.05639 -9.88004 -9.22537 +36 2 1.89707 3.34621 12.2331 21.1403 -27.4328 37.6181 +37 1 2.11621 6.94729 8.0812 -5.52003 -16.2776 -1.04121 +38 2 2.5746 7.45442 8.7366 8.45236 15.6822 11.2536 +39 2 2.08388 6.07661 8.50513 -4.57751 -6.44388 -7.47435 +40 1 5.24695 4.43578 7.8028 -6.30612 26.2857 -2.69952 +41 2 5.36677 3.49844 7.65426 0.215716 -12.5366 -1.65761 +42 2 4.56392 4.76953 7.18377 10.1949 -9.65667 2.91339 +43 1 3.43524 2.88686 17.4376 -21.7675 5.87472 14.6558 +44 2 3.90981 3.17382 16.6701 17.8952 10.4272 -14.0542 +45 2 2.87759 3.6541 17.6984 8.18662 -9.04753 2.1829 +46 1 7.55778 5.57378 6.15352 3.99821 9.40639 19.9011 +47 2 8.12518 6.20749 6.66299 -12.9927 -14.0765 -9.88952 +48 2 6.98227 5.15891 6.82729 7.75312 -1.10557 -10.9113 +49 1 9.77611 7.00478 12.0482 -6.90333 -2.64414 -8.04886 +50 2 10.0224 6.11753 11.7611 0.642082 2.81741 -0.891425 +51 2 9.0843 7.2891 11.4183 2.80801 -0.947675 5.79882 +52 1 14.1423 3.90191 8.16294 -23.6925 4.35767 -24.2753 +53 2 13.5235 4.53411 7.72337 18.2577 -11.8103 7.89417 +54 2 14.4024 4.31063 8.97869 6.95814 7.70003 16.5888 +55 1 4.54437 17.2359 3.8519 4.03565 10.1791 3.31349 +56 2 5.34213 17.7268 4.08304 4.36901 -6.62302 -0.267376 +57 2 4.17051 17.7127 3.09453 -6.96766 -2.87365 4.53203 +58 1 16.1339 16.4921 10.5971 24.4543 -12.0388 -34.7313 +59 2 15.4578 16.6815 11.2098 -23.1752 5.77424 26.3474 +60 2 15.6745 15.9439 9.92709 9.81353 9.26167 7.23238 +61 1 1.98282 4.87023 -0.0102057 11.328 -31.2723 15.691 +62 2 2.56866 5.25094 0.666382 -3.10152 5.14206 -1.69339 +63 2 1.65849 5.5885 18.1127 -8.58794 22.0564 -11.6074 +64 1 11.0975 13.3336 16.4568 21.334 -26.4555 -13.6253 +65 2 10.7319 12.43 16.5661 -7.83355 14.7592 4.38577 +66 2 11.7328 13.1734 15.7328 -3.59268 8.82171 6.12988 +67 1 9.983 10.9188 16.8195 21.8027 -17.9597 14.5818 +68 2 10.5015 10.1139 17.0687 -12.258 16.9146 -11.8156 +69 2 9.08607 10.6082 16.6912 -8.94921 1.38614 -3.26281 +70 1 11.9148 17.5563 13.4787 -11.9158 -12.5975 -1.23623 +71 2 12.5676 17.2101 12.8515 -0.0246338 2.67811 4.16536 +72 2 12.0003 18.5089 13.4756 8.75914 10.3848 -3.31648 +73 1 6.43245 9.54572 12.2957 1.63429 -3.34072 -14.2423 +74 2 7.08046 9.15867 11.6656 -10.0512 7.63496 6.98562 +75 2 6.90317 10.1892 12.8448 2.76093 -9.73394 -7.4892 +76 1 16.2985 12.7819 2.78073 -6.76278 9.02259 -0.251856 +77 2 17.1507 13.1937 2.56739 -3.11425 -2.92719 1.79117 +78 2 15.6658 13.5347 2.78258 7.1706 -12.5209 -0.796151 +79 1 0.705375 12.7757 5.80641 -31.4327 0.785322 -26.0818 +80 2 0.964058 12.7408 4.86595 9.86444 -3.28161 8.94612 +81 2 18.3663 12.6813 5.72517 19.7421 -2.33124 11.5636 +82 1 5.30386 16.3127 18.466 5.80758 -1.43031 -6.37222 +83 2 5.80257 15.6526 17.9366 -5.42534 13.184 13.7491 +84 2 5.92544 16.7092 0.45256 -3.43112 -6.46136 -2.11967 +85 1 0.781035 7.63768 4.09742 11.023 -5.93732 13.9838 +86 2 0.258202 7.96457 3.37539 -14.755 3.95315 -10.1558 +87 2 1.66078 7.97253 3.8829 3.26007 -0.00880383 4.41534 +88 1 3.24417 9.16605 6.56429 -20.4701 -14.3326 2.83801 +89 2 3.57159 8.65908 7.31953 1.49107 7.58135 -6.52778 +90 2 2.30098 8.88971 6.4655 20.5558 12.7829 2.43715 +91 1 7.26627 10.4004 16.2591 -15.7562 -6.32656 27.9079 +92 2 6.82075 11.2368 16.4586 5.73239 -2.42146 -6.93429 +93 2 6.93167 9.82605 16.9811 6.22417 8.86745 -10.8084 +94 1 10.9892 0.849679 5.07849 4.12027 -5.76689 -13.93 +95 2 11.0513 1.64213 4.53259 0.725375 9.02843 9.39609 +96 2 10.6504 0.238952 4.4041 -0.868918 -3.08012 11.6628 +97 1 4.18223 2.98976 13.1617 1.80285 -9.79496 -4.9743 +98 2 4.46754 3.28562 14.0477 -4.0491 -7.36491 -7.89898 +99 2 4.03841 2.01285 13.1683 3.67857 16.3758 11.7633 +100 1 8.4888 10.2856 1.85141 10.3375 -10.6918 -8.28538 +101 2 8.43451 10.9691 2.52904 -3.58901 -0.686288 7.94652 +102 2 8.82874 9.48425 2.29142 -6.1923 10.8646 1.43904 +103 1 10.2336 1.64305 15.4458 -13.2429 9.10796 4.38269 +104 2 11.1732 1.63861 15.572 16.9305 -2.55664 -1.17381 +105 2 10.0536 2.05804 14.5895 6.55462 -3.46994 -1.37038 +106 1 2.58993 12.7242 7.97336 -7.23425 -8.94691 3.8681 +107 2 3.01571 13.5704 7.82234 5.57764 5.06786 -6.45979 +108 2 1.98486 12.5774 7.23174 0.806159 4.05811 0.362671 +109 1 3.90685 11.8307 5.02738 -19.955 -7.05304 -0.3571 +110 2 3.70751 11.1281 5.68153 3.09094 12.242 -8.4391 +111 2 3.06715 12.0092 4.53628 19.8771 -7.15241 7.2697 +112 1 6.7679 14.5791 16.9276 2.77817 -6.983 11.0716 +113 2 7.71708 14.7379 16.9268 0.980214 1.28706 0.809355 +114 2 6.44853 14.8723 16.076 -0.709014 -5.22289 -12.1565 +115 1 14.1752 14.508 3.1348 7.33594 -12.7834 -7.22412 +116 2 13.6105 15.2801 3.10139 -3.55206 9.35654 4.80996 +117 2 13.7682 13.8754 3.73922 -4.33905 3.15851 6.00261 +118 1 8.77346 18.0937 16.1268 -49.3086 -19.2657 7.09896 +119 2 9.29148 17.2891 16.2682 10.0054 9.31596 -1.94744 +120 2 9.22615 0.228463 15.833 27.8858 8.66202 -5.29688 +121 1 4.63977 1.75161 4.89947 12.6555 12.3233 -26.7382 +122 2 3.82082 2.25711 4.97207 0.159842 -3.07614 2.23584 +123 2 5.05477 2.09313 4.05862 -7.26402 -10.6651 28.8422 +124 1 15.0293 12.6717 16.5117 -23.31 -0.861404 35.6256 +125 2 14.4426 12.7177 17.3057 24.815 2.28331 -11.4604 +126 2 14.393 12.496 15.8301 -9.60755 -0.359254 -28.8722 +127 1 15.7282 18.4115 16.8424 17.2085 30.6847 -2.58542 +128 2 16.585 18.5255 17.3163 -17.0651 -10.3906 -2.34083 +129 2 15.5073 17.4884 16.7844 1.64687 -19.4864 2.05956 +130 1 1.3653 1.32145 16.674 4.57571 12.7751 22.4809 +131 2 2.22966 1.72757 16.8986 -13.3853 -7.67206 -8.47788 +132 2 0.843747 1.53379 17.4789 2.23908 -6.3926 -16.4011 +133 1 18.2502 4.28823 15.9426 5.59379 -7.24598 -18.3859 +134 2 17.8025 3.49471 15.6029 3.53909 11.4984 4.55434 +135 2 0.380345 4.42598 15.3659 -10.3938 -1.91133 11.4 +136 1 12.0179 17.0993 16.1449 -24.7595 -29.8482 27.6473 +137 2 11.2904 16.5264 16.5371 30.7476 29.6052 -3.96723 +138 2 11.7854 17.0696 15.2267 4.30162 8.23296 -25.5613 +139 1 16.0455 2.77586 18.2041 10.6955 -6.31261 -1.53201 +140 2 15.9135 3.65525 18.5895 -10.0784 -5.09061 -10.2232 +141 2 15.7148 2.7749 17.2908 -2.70848 4.2718 2.75475 +142 1 6.57887 13.7167 10.0128 0.388305 24.4332 24.1101 +143 2 6.2636 13.3347 10.8463 6.37938 -3.40375 -0.55213 +144 2 6.43171 13.0818 9.3305 3.17506 -19.669 -12.997 +145 1 10.1062 18.565 2.71626 12.0596 2.32822 -17.6158 +146 2 10.7563 0.294125 2.0815 -9.9929 -7.47975 8.60443 +147 2 9.2984 18.4331 2.20633 -1.12272 -0.999648 5.59115 +148 1 3.10044 17.6571 6.21769 -0.590198 -1.20238 18.0356 +149 2 2.16339 17.7471 5.9649 14.558 -0.242179 -11.811 +150 2 3.6505 17.6877 5.42436 -8.00238 0.252249 -9.63341 +151 1 12.5899 16.7797 7.85568 11.434 -9.28582 -14.859 +152 2 11.8995 16.1049 7.73478 -4.76829 8.38316 1.604 +153 2 12.3367 17.3735 8.55676 -7.89443 8.69289 16.0625 +154 1 14.8958 15.3252 8.42405 -10.9907 16.0866 -10.412 +155 2 14.2257 15.9607 8.05927 9.60746 -16.915 15.6813 +156 2 15.568 15.2992 7.73812 1.83068 -0.846784 -8.90808 +157 1 17.9236 18.2959 0.16927 -20.6229 -20.5305 -14.2597 +158 2 18.7101 17.7336 18.8116 8.98564 4.8691 -3.01699 +159 2 18.0908 0.428516 0.675884 12.0916 17.8267 11.1415 +160 1 0.800533 10.4853 1.48213 -15.9305 -52.1134 32.1201 +161 2 0.0210499 9.87138 1.72712 35.348 27.3948 -12.4938 +162 2 0.488783 11.092 0.839839 -12.4886 25.7711 -24.5144 +163 1 1.85398 12.3107 3.26054 -2.39029 3.71051 2.5874 +164 2 1.61156 11.5651 2.68837 -2.80207 3.45241 0.205878 +165 2 2.01622 13.0664 2.66785 -2.08994 -5.59574 4.32216 +166 1 0.726068 17.2941 4.97534 23.1964 8.93599 -27.6283 +167 2 -0.00504426 17.9045 4.96895 -11.3657 3.83105 9.40925 +168 2 0.6848 16.6356 5.64734 -16.8394 -17.6158 22.5419 +169 1 0.979774 0.931094 9.39103 18.34 6.67236 9.68687 +170 2 1.13606 0.587208 10.3041 -6.25966 0.627701 -15.4141 +171 2 0.222638 0.493139 9.00427 -6.20505 -6.29115 6.11619 +172 1 16.8132 2.44689 13.4524 12.1018 18.2567 -5.29927 +173 2 16.9941 2.74318 12.5312 -5.60486 -9.11594 12.8952 +174 2 16.5475 1.52939 13.4414 -4.39811 -15.2301 -8.28386 +175 1 2.68823 16.0572 12.0971 4.35106 -7.5731 1.60029 +176 2 3.00862 15.6347 12.9147 -3.00711 3.68751 -12.4652 +177 2 3.25289 15.7623 11.3532 -3.53001 -2.50035 7.7005 +178 1 16.365 15.3972 6.07793 1.10786 -2.726 6.22736 +179 2 17.2616 15.5854 6.39959 0.338369 -3.43469 -2.74975 +180 2 16.1217 16.1306 5.49548 2.77772 2.55878 -2.13745 +181 1 5.71885 5.23685 11.7571 -1.38587 -22.0348 -7.59079 +182 2 5.34065 5.94353 12.2818 1.95161 11.9795 4.35233 +183 2 5.13977 4.47517 11.9216 1.17844 4.76848 -1.31072 +184 1 15.1029 4.9502 0.771222 1.99697 3.13949 16.3358 +185 2 15.0181 4.74755 1.72068 1.03511 -0.706475 -1.64751 +186 2 14.2572 5.32925 0.539529 -7.17443 2.24029 -6.36177 +187 1 16.4241 16.5209 1.77175 11.7834 22.2537 -31.9797 +188 2 16.1353 16.901 2.59837 -3.82757 4.70614 16.3909 +189 2 16.7243 17.3043 1.2165 -7.10171 -29.7856 17.5505 +190 1 0.166785 4.90105 4.02875 -9.807 6.14851 -6.2016 +191 2 0.490919 5.80972 4.19933 1.47178 -10.2493 -2.87817 +192 2 0.85797 4.25703 4.16889 13.481 4.94217 6.1798 +193 1 2.95388 15.1092 15.162 10.7369 -8.35154 -8.83455 +194 2 2.79081 14.8128 16.074 0.0767364 3.70074 1.09557 +195 2 2.55949 15.9866 15.0864 -8.26758 5.41964 7.36053 +196 1 1.08589 14.7081 9.5149 24.8711 -1.95174 9.92838 +197 2 2.02655 14.926 9.73253 -22.6422 -7.57261 -8.5802 +198 2 0.981604 13.769 9.74603 1.17561 7.47496 0.770389 +199 1 13.5787 16.5188 11.5692 -12.2314 13.2219 -8.78769 +200 2 13.3397 17.246 10.9551 -0.181138 -8.24863 9.65793 +201 2 12.9892 15.7954 11.3146 2.83531 -7.80051 -5.41791 +202 1 4.81777 1.55092 0.678258 -26.6156 -3.92273 4.29753 +203 2 4.35705 2.21925 0.160828 3.99581 1.83661 -5.90848 +204 2 4.05187 1.04139 1.04246 22.8613 -3.7169 0.169547 +205 1 1.54475 18.6679 11.892 -7.41525 16.2224 7.56704 +206 2 1.47416 0.586534 12.6867 1.33096 -5.97454 -6.01551 +207 2 1.79005 17.7987 12.209 7.72027 -7.46968 0.191542 +208 1 11.4358 10.1471 4.23265 -10.894 -3.87129 -8.35951 +209 2 11.2613 10.4034 3.31126 9.28636 4.56211 3.82985 +210 2 12.3915 10.0236 4.32197 -4.85978 3.43988 -0.432274 +211 1 8.20336 12.1359 3.88849 -13.0458 16.1374 35.7669 +212 2 8.99874 12.5954 4.16275 16.0075 -1.33649 -14.8839 +213 2 7.69556 12.2697 4.73273 -2.96338 -15.3566 -29.2591 +214 1 14.5957 4.06338 3.37559 11.9385 -4.24509 -11.5663 +215 2 15.1907 4.01381 4.14053 1.35901 4.80596 -1.61984 +216 2 13.7786 4.41816 3.71066 -15.4173 6.10577 6.17301 +217 1 5.71905 1.6749 7.61995 8.80947 6.26404 67.7498 +218 2 5.099 1.08549 8.07836 1.13728 7.44943 0.131268 +219 2 5.55556 1.51371 6.73852 -13.1925 -8.9768 -74.4163 +220 1 17.8986 1.04478 4.82737 2.1754 -1.83476 -0.744307 +221 2 18.4917 1.14925 4.06283 -1.19754 2.46044 8.41233 +222 2 18.3052 1.49477 5.5864 -1.29774 -0.0865267 -3.68542 +223 1 6.84138 9.15652 4.5536 4.1666 1.31036 -3.45285 +224 2 6.90548 9.53593 5.43168 -5.85674 1.32054 6.56912 +225 2 7.76285 8.95875 4.34348 -1.51129 -0.833856 -3.18299 +226 1 2.51554 14.7147 2.08788 -0.0450507 -1.43316 -6.26715 +227 2 3.18184 14.7861 2.78103 3.7873 -1.55841 0.251503 +228 2 3.00277 14.5163 1.27395 -5.30581 6.45149 3.77223 +229 1 17.2192 13.0031 13.0554 -12.0926 -3.19634 4.57291 +230 2 16.3553 13.3969 13.3572 27.3304 0.34804 -8.60607 +231 2 17.7786 13.6982 12.6582 -16.3476 4.90844 7.68697 +232 1 14.8182 10.5634 1.61386 4.26778 13.3748 6.0388 +233 2 15.4677 11.1895 1.9919 -6.32062 -5.48184 -5.48699 +234 2 13.979 11.0422 1.62876 3.88819 -6.35193 -1.63244 +235 1 5.61579 6.74404 4.50101 -16.4591 -25.6922 -2.42498 +236 2 5.98931 7.61359 4.54862 8.72135 21.7956 -0.434523 +237 2 6.18395 6.1944 5.05334 5.89398 3.69136 0.98365 +238 1 7.99723 8.25195 10.2692 14.8304 8.84149 10.0706 +239 2 8.65992 8.88256 9.91656 -9.90097 -8.80766 -1.78449 +240 2 7.59566 7.7759 9.52484 -1.48617 9.19501 4.49734 +241 1 13.4628 18.4324 5.71378 17.6235 1.75148 -9.47684 +242 2 12.708 0.350866 5.56458 -19.7852 7.87128 -2.36248 +243 2 13.2811 17.9777 6.53219 -7.30606 -12.1428 7.93723 +244 1 0.0668655 2.55772 0.44163 -1.64079 -15.5797 1.12414 +245 2 17.7792 2.62308 0.158326 7.01821 10.3157 -4.2768 +246 2 0.560589 3.37114 0.261458 -5.35649 7.7487 -2.70304 +247 1 12.8473 10.8167 9.6749 -29.1069 48.3462 -20.1155 +248 2 11.856 10.995 9.62541 32.1605 -20.6147 5.13184 +249 2 13.0142 9.92242 9.94244 -8.5776 -22.9331 5.75343 +250 1 0.607197 12.3488 11.1216 10.7177 -2.21067 3.69277 +251 2 18.3016 12.4338 11.1296 -15.0263 -0.672926 -5.71109 +252 2 0.887353 12.7089 11.9725 7.71276 -2.01358 -2.19338 +253 1 5.32001 7.36668 13.2938 5.32433 15.1635 7.63099 +254 2 5.70557 8.20602 12.9842 -2.91102 -7.98825 -6.07053 +255 2 5.82609 7.21997 14.1065 -9.96591 -5.08448 1.55341 +256 1 1.1733 6.74916 11.943 -30.749 -23.7015 -12.6924 +257 2 0.265139 7.01822 11.7017 14.0517 -0.957096 2.97943 +258 2 1.61086 7.53614 12.2133 15.6557 23.6476 13.031 +259 1 15.5486 9.75906 12.4999 -0.653644 29.4777 3.96245 +260 2 15.1521 10.5891 12.1135 7.41979 -25.1975 16.8694 +261 2 15.9641 10.0301 13.3422 -9.48671 -5.05259 -12.6364 +262 1 16.5044 12.5382 5.51299 -3.50049 1.7151 -41.7779 +263 2 16.2902 13.4721 5.54585 0.30498 11.7411 21.1442 +264 2 16.3754 12.4207 4.53497 7.77761 -11.637 24.1999 +265 1 6.32544 9.92844 0.21289 -23.4091 -5.64021 -11.1485 +266 2 5.58447 10.3552 0.689761 9.59747 -6.57127 -5.34636 +267 2 7.10511 10.1371 0.71679 14.7949 3.34633 14.2781 +268 1 12.1134 5.97718 4.01208 -22.8865 -14.7559 9.656 +269 2 12.2541 6.73773 3.46345 4.76282 13.7738 -16.8186 +270 2 11.1454 5.80116 3.92348 22.2207 -1.187 3.16864 +271 1 0.310021 12.9061 0.00438974 -4.95288 1.79463 -7.14095 +272 2 18.578 13.473 0.695812 6.768 -1.51286 0.947724 +273 2 18.4929 13.1888 17.8371 0.864006 -6.25549 9.7975 +274 1 3.57649 0.0893425 8.67318 10.7138 1.44606 -23.5182 +275 2 3.53585 18.3471 7.78602 0.204258 -6.73647 -0.0210952 +276 2 2.75019 0.556646 8.71194 -17.5671 6.50862 13.0872 +277 1 7.32229 17.553 4.46711 -1.8346 22.7033 -6.51397 +278 2 7.49747 18.5341 4.60164 1.92735 -36.6431 -12.1684 +279 2 7.43093 17.3591 3.50845 0.44318 8.65947 16.4016 +280 1 9.23372 17.1692 12.2368 -1.40541 18.7929 10.7586 +281 2 9.17923 16.5713 11.4947 6.54031 -16.824 -6.24154 +282 2 10.1445 17.1937 12.5849 -6.50468 -4.83213 -2.69749 +283 1 13.3883 13.1392 7.89062 -8.44361 -29.718 12.0449 +284 2 13.2983 12.3346 8.48336 5.26587 25.8846 -16.8323 +285 2 14.1176 13.673 8.22732 -1.02664 3.48474 5.19869 +286 1 14.8313 2.83639 15.4549 13.5448 -0.0778016 6.35676 +287 2 14.1767 2.18003 15.2177 -4.87233 -8.03631 -4.89691 +288 2 15.4971 2.82305 14.7488 -5.52573 3.83225 -1.21536 +289 1 9.88985 15.6498 16.9162 -1.5178 12.6863 -12.8881 +290 2 10.4068 14.8878 16.6522 -4.3383 -15.6303 0.424585 +291 2 9.57752 15.4658 17.7984 -6.29913 -5.39682 13.2163 +292 1 11.1832 8.45041 16.604 0.69795 7.62392 -5.91094 +293 2 10.4558 7.91494 16.2714 -2.08228 -2.22425 -3.83894 +294 2 11.7364 7.86183 17.1086 3.16052 -9.92137 8.33691 +295 1 3.98058 18.2281 16.8796 4.69725 -6.17709 8.80305 +296 2 4.47544 17.5796 17.4031 -3.04366 -6.21568 -3.2578 +297 2 4.2975 0.415113 17.2284 -3.71051 8.24157 -1.82763 +298 1 2.31186 4.29334 8.90298 15.9673 -19.5394 32.2139 +299 2 3.25638 4.01729 8.88792 -18.4415 10.5974 -6.3491 +300 2 2.00846 3.99585 9.80326 5.50039 13.6474 -24.2252 +301 1 9.93626 10.4071 9.85717 -7.16433 6.26663 -15.7674 +302 2 9.36967 11.1624 9.60099 8.89086 -7.49456 6.1891 +303 2 10.0442 10.3828 10.8072 -0.648607 3.91668 13.0823 +304 1 9.8312 0.910661 10.8223 11.6198 7.73817 -5.63486 +305 2 9.46664 0.0599513 11.0613 -12.5627 -8.03565 7.40448 +306 2 9.23233 1.33675 10.1908 -3.5905 -1.89286 -1.84539 +307 1 9.13587 15.2239 10.1542 8.27875 -9.17261 13.8125 +308 2 8.75897 15.8188 9.50902 -6.94043 7.83547 -6.48358 +309 2 8.46187 14.5466 10.3059 -2.40816 2.69742 -4.7236 +310 1 0.685213 9.67274 10.114 -7.63752 22.5158 18.5003 +311 2 0.719625 10.5209 10.6443 4.69174 -21.4783 -21.4849 +312 2 1.56632 9.47392 9.79675 4.15873 2.44002 -0.184199 +313 1 17.1428 4.74332 7.9842 -7.49261 0.0436566 15.7002 +314 2 16.4923 5.43036 8.24486 9.33931 -9.59151 -5.74994 +315 2 17.1543 4.09081 8.70481 -1.62938 8.73821 -5.69634 +316 1 14.873 14.5838 0.184633 -12.5055 -0.863041 8.47648 +317 2 15.4452 15.0773 0.785336 2.49238 5.2379 -3.7088 +318 2 14.1221 14.3325 0.749692 6.56524 -1.80757 -8.31994 +319 1 3.93739 11.0893 9.63941 -1.02455 -14.3236 -20.6383 +320 2 3.83455 11.1931 10.5803 -4.40039 8.60569 15.1914 +321 2 3.22961 11.5882 9.19534 2.92088 3.20496 1.27781 +322 1 11.4787 10.7372 1.42758 24.3197 -0.772389 9.7934 +323 2 11.803 11.5915 1.09275 -4.97826 -3.71445 3.9898 +324 2 10.5984 10.6629 1.1011 -26.1902 -1.18673 -8.43185 +325 1 13.1873 7.21634 12.6041 -15.1781 -16.7535 7.59792 +326 2 14.1321 7.04558 12.6338 7.66113 -4.04391 -1.22332 +327 2 12.7625 6.33802 12.7657 6.99529 16.5731 -3.03327 +328 1 9.70202 2.01155 0.798053 14.7354 3.6785 18.4689 +329 2 8.80874 1.78739 0.563168 -12.7542 -2.84597 -8.5823 +330 2 10.1462 2.35336 0.0231027 2.1886 1.53799 -6.67264 +331 1 10.5601 13.4177 4.61479 15.5689 5.45852 21.4774 +332 2 11.4398 12.9929 4.68798 -8.71776 0.745444 -2.53542 +333 2 10.4627 13.8549 5.48714 -1.1208 -2.16649 -13.1077 +334 1 14.6135 1.64587 10.9888 -15.9483 2.47769 1.03658 +335 2 15.3653 1.14828 10.6398 3.3395 9.35485 -7.37665 +336 2 14.6055 2.55489 10.6162 9.33106 -12.1869 7.67578 +337 1 14.4205 12.072 11.5247 -14.0438 -11.3661 -21.2086 +338 2 15.2325 12.1783 11.0185 5.83651 11.9615 0.736203 +339 2 13.7775 11.7491 10.8405 12.2041 8.47933 23.407 +340 1 8.16075 5.17074 9.91542 -32.2508 22.4833 15.2463 +341 2 7.26447 5.43351 10.2769 29.6925 -9.34554 -9.10024 +342 2 8.08912 4.23235 9.75273 2.68018 -15.2376 -3.85437 +343 1 1.73754 17.0197 18.4251 17.7604 24.8388 -20.6387 +344 2 2.31535 17.5448 17.7835 -20.2636 -19.608 22.2942 +345 2 1.91865 16.0976 18.2314 3.71033 -9.13614 -1.37747 +346 1 1.38218 17.4352 15.3141 25.6123 -1.10879 -8.05345 +347 2 1.40837 18.2867 15.7687 -7.1514 0.273564 3.63966 +348 2 0.483975 17.1212 15.2601 -14.2857 -2.70278 3.05549 +349 1 3.46713 5.71669 6.03858 -5.21329 -0.208659 9.269 +350 2 3.09179 6.35885 6.66621 -4.29108 -6.04245 -5.71481 +351 2 3.94628 6.22951 5.39233 13.1871 8.33197 -8.25473 +352 1 12.7108 9.52885 14.2713 4.43437 -19.6411 -8.16456 +353 2 13.1132 8.73466 13.871 -3.04318 14.9787 -8.97539 +354 2 12.4252 9.15135 15.1011 -11.0135 5.38653 13.5706 +355 1 4.12803 15.1962 7.19495 12.4066 -8.66704 -3.75127 +356 2 3.59847 15.8823 6.77325 5.03517 9.17322 -2.57748 +357 2 5.08076 15.3227 6.96437 -18.0652 5.77836 0.725546 +358 1 0.842345 8.89099 15.1297 2.31502 -25.1166 0.479797 +359 2 0.506769 9.78853 15.0967 4.66165 8.13805 -4.97691 +360 2 1.56169 8.8202 14.4757 -4.5077 5.49756 1.76436 +361 1 12.9722 8.22706 10.1223 30.4908 -35.0116 2.62512 +362 2 13.7358 7.69898 9.75664 -18.6412 19.8455 -0.140907 +363 2 12.9154 7.83668 11.013 -6.3959 11.2287 -1.2259 +364 1 15.209 8.0796 3.38747 1.18456 -35.8933 6.76248 +365 2 14.5518 7.57266 2.91157 -10.3511 16.9608 -18.4151 +366 2 15.3784 7.42989 4.0872 14.9983 19.582 11.3682 +367 1 17.1108 6.70081 18.626 -14.4882 23.5427 -0.564853 +368 2 16.573 5.93167 0.182006 3.19594 -3.93797 2.70551 +369 2 16.4292 7.40436 18.4932 17.3888 -11.7094 -2.73385 +370 1 8.93374 7.05508 7.97597 -34.6157 -22.4872 9.48373 +371 2 9.83531 7.32727 7.97774 29.5921 7.62374 2.22252 +372 2 8.80811 6.41093 8.72029 6.54491 10.6746 -16.3243 +373 1 12.5312 0.423333 1.1911 6.44852 -9.8202 9.01884 +374 2 13.2753 0.834119 1.64897 1.63592 5.99122 -1.78887 +375 2 12.9315 0.0607692 0.396252 -6.77848 2.89528 -3.69601 +376 1 5.75537 14.98 14.4363 12.3645 2.0371 -4.21343 +377 2 4.82148 15.0687 14.6213 -16.3449 4.01416 5.01671 +378 2 6.0882 15.8478 14.162 -3.83146 3.10822 0.706071 +379 1 3.69037 6.49544 1.72037 -3.07239 6.81288 -7.41536 +380 2 3.43088 7.36249 1.36332 1.27628 -12.1507 -2.18765 +381 2 3.67848 6.67228 2.6574 4.23334 -3.71069 10.2966 +382 1 3.82256 11.2843 12.3046 -0.864415 -4.77059 0.0245619 +383 2 4.71622 11.5939 12.5181 -0.579536 5.4381 2.57712 +384 2 3.18979 11.9063 12.6819 -0.230908 7.2683 5.57723 +385 1 5.33149 3.8717 15.6726 -21.611 69.2317 6.1195 +386 2 6.02506 3.28248 15.4947 35.9646 -33.3333 -4.61122 +387 2 5.75271 4.79171 15.6869 -18.1046 -35.0984 -1.75377 +388 1 13.9893 10.0773 4.7789 22.4286 4.91544 -48.853 +389 2 14.2819 9.66907 5.58109 5.23319 -9.97863 19.9681 +390 2 14.5573 9.69868 4.0468 -17.0356 6.64649 24.2901 +391 1 7.62039 17.28 9.03644 -1.79817 -13.3385 2.54351 +392 2 6.82618 17.452 9.57294 2.68689 7.94648 -2.92213 +393 2 7.87136 18.0666 8.53956 -0.560867 8.99315 -4.02364 +394 1 4.58082 14.4709 3.89205 3.13293 1.46958 -13.0867 +395 2 4.66344 15.3386 4.31009 -0.0981131 -0.860678 2.59791 +396 2 4.56838 13.761 4.54421 -0.137719 -0.424919 8.72805 +397 1 14.11 7.4138 15.8858 20.156 9.8447 -1.08692 +398 2 14.9007 7.50898 15.3123 -12.2349 -4.78906 9.9244 +399 2 14.35 7.89712 16.7003 -4.15301 -9.39138 -6.29924 +400 1 2.88871 18.3931 1.90601 -10.0733 25.2579 5.70796 +401 2 2.56074 17.6209 1.45485 -4.97176 -8.65563 -11.6917 +402 2 2.08224 0.29716 2.10455 27.8478 -15.7521 2.2348 +403 1 8.03506 1.57584 4.43091 11.32 6.26446 5.75526 +404 2 7.34029 2.01323 3.92479 3.96785 0.109851 -4.32136 +405 2 8.88243 1.87946 4.04557 -12.5027 -7.48646 4.71123 +406 1 2.59748 14.2159 17.7933 -41.9258 1.66076 -8.0641 +407 2 1.85609 13.5734 17.9588 19.2075 16.8599 2.55802 +408 2 3.39352 13.7425 17.9784 23.6145 -16.2032 6.42715 +409 1 1.02442 1.99672 13.9281 17.4639 2.95853 -13.5386 +410 2 1.00308 1.87917 14.8709 4.63864 -6.80727 18.6653 +411 2 18.7659 2.1043 13.6716 -21.6962 3.88026 -3.66909 +412 1 4.27686 0.20187 13.9044 10.5162 4.04171 -16.044 +413 2 5.10447 18.3372 13.9403 -4.05013 6.4475 2.1433 +414 2 3.72354 18.5099 14.5979 -6.57077 -5.71295 14.511 +415 1 7.38305 1.01959 18.4815 -37.4449 7.12948 8.58409 +416 2 7.61008 0.74545 17.6036 5.58611 -6.30497 -21.5445 +417 2 6.41018 1.26146 18.4662 31.347 -10.6343 7.25927 +418 1 15.7518 18.4403 13.8831 -5.31168 6.41878 -7.08883 +419 2 14.7988 18.525 13.6912 13.3949 -2.54728 9.28792 +420 2 15.9153 18.5927 14.8217 -8.96218 -2.42265 4.9219 +421 1 10.3004 4.59906 16.2125 -26.9192 -42.5531 9.44494 +422 2 11.2318 4.75068 16.1287 26.1471 2.80018 1.93501 +423 2 10.2211 3.60629 16.3773 -0.864587 37.9812 -10.9337 +424 1 15.8848 17.7109 4.47524 -26.0192 -17.7161 -6.69824 +425 2 16.416 18.4558 4.72522 12.9982 18.1701 2.23702 +426 2 14.9575 17.9834 4.62838 14.848 -2.41832 2.25768 +427 1 6.86545 17.6577 14.0262 -6.12412 -8.41921 6.45462 +428 2 7.47866 17.6693 14.7646 2.09746 6.93436 13.8689 +429 2 7.44902 17.4838 13.2997 11.4214 -0.145135 -19.8537 +430 1 13.1703 6.41318 6.52816 -11.7529 -0.316938 -15.1514 +431 2 13.9829 6.90375 6.37155 7.88734 -3.14145 2.99861 +432 2 12.7537 6.33512 5.64174 6.34445 -4.78434 12.9923 +433 1 7.85335 2.30114 9.49646 -14.1039 1.33546 -28.6309 +434 2 7.23443 2.06415 10.1901 -3.07143 2.26257 12.1486 +435 2 7.33833 2.15664 8.66054 15.7097 0.546065 18.7565 +436 1 15.1664 14.7315 13.8676 -13.4222 3.7476 -0.777794 +437 2 14.8716 15.1233 14.7167 4.70885 -6.20173 -11.3706 +438 2 14.4912 14.9291 13.1959 7.90291 2.0321 9.20294 +439 1 9.36434 8.4507 3.85153 -5.45323 -8.44175 -9.3174 +440 2 10.195 8.80526 4.18009 6.07261 4.07641 1.89943 +441 2 9.48655 7.50041 3.73575 1.17631 -1.18483 4.07146 +442 1 17.585 13.5529 16.4533 28.0827 9.29223 -15.0932 +443 2 16.6463 13.3857 16.5308 -13.0105 5.34146 -4.98563 +444 2 17.7372 14.3421 15.8749 -12.9185 -11.1551 11.5131 +445 1 5.00344 10.4544 2.83444 15.3623 2.39709 8.30796 +446 2 5.84337 10.0047 3.04968 -12.8086 4.14038 -0.288119 +447 2 4.84487 11.029 3.60723 -3.54173 -2.25206 -8.41364 +448 1 3.64071 8.37653 9.83285 -3.63557 -2.42467 19.3481 +449 2 3.86873 9.30617 9.70655 -0.364806 7.27712 -2.43853 +450 2 3.42279 8.30417 10.789 5.82381 -0.771913 -15.5307 +451 1 16.012 6.92262 5.85834 3.10414 -0.205141 -1.95775 +452 2 16.7064 7.38617 6.35888 -2.44937 -6.94247 -7.87698 +453 2 16.3342 6.01666 5.66219 -6.01431 14.0457 5.91674 +454 1 15.3573 7.28861 8.91428 -7.73552 23.9623 -29.5509 +455 2 15.9286 7.60908 9.59449 17.6585 1.69923 20.6432 +456 2 15.3281 8.05346 8.27817 -7.4668 -29.0722 12.6462 +457 1 6.23444 12.7891 12.7562 -16.1216 7.07791 -6.67583 +458 2 7.04381 12.3675 13.028 12.7717 -9.63916 7.37694 +459 2 6.08648 13.5082 13.3891 2.20208 -1.21591 -2.77254 +460 1 12.1275 4.60499 13.1618 30.5736 27.4894 8.79026 +461 2 12.1815 4.60813 14.1323 1.45244 -2.14521 -6.91324 +462 2 11.4269 4.052 12.8891 -30.6572 -22.7655 -2.33684 +463 1 11.4418 8.05897 7.8749 4.39649 -6.11408 4.26725 +464 2 12.0054 7.38105 7.40707 -4.89778 19.9996 19.2901 +465 2 11.7913 8.23063 8.79017 -1.61454 -12.0828 -25.9053 +466 1 16.8934 10.7552 7.64898 5.958 -15.487 6.46706 +467 2 17.5218 10.034 7.45777 0.434714 4.65833 3.39608 +468 2 16.8005 11.223 6.82193 -0.787623 15.1873 -12.5781 +469 1 5.19162 18.0101 10.6182 -11.7475 -9.51575 -5.50364 +470 2 4.6689 17.2843 11.0141 12.267 13.7571 -4.22389 +471 2 4.61649 18.3258 9.88348 13.0529 -7.1725 20.3587 +472 1 7.61953 17.4141 1.49962 -5.28373 3.7131 11.8258 +473 2 8.17503 16.7132 1.19553 7.57367 -21.9054 -5.9523 +474 2 7.57614 18.0024 0.755384 -3.403 20.0604 -6.05803 +475 1 1.93154 12.9424 13.6297 4.26026 1.62766 0.165619 +476 2 1.31807 12.4855 14.2164 3.08324 -4.19991 0.575461 +477 2 2.34989 13.6289 14.1741 -4.48691 2.36366 -2.57882 +478 1 9.34851 6.7636 14.8211 -2.90069 2.43692 -15.7898 +479 2 9.659 5.88476 15.1078 3.08688 5.56829 -7.87962 +480 2 9.50722 6.89182 13.8456 0.484936 -6.74561 22.7152 +481 1 15.2631 4.37275 10.7209 -0.391742 -1.67154 5.71992 +482 2 16.1506 4.03655 10.897 1.37527 -0.677682 -8.66997 +483 2 15.1154 4.97006 11.4686 -2.24536 -2.27818 -6.11794 +484 1 11.4934 6.22632 -0.0241442 -6.06296 -11.7718 -8.66306 +485 2 11.6483 5.30933 -0.309107 4.27028 6.28431 2.83608 +486 2 10.5284 6.3165 18.5406 6.28072 6.83613 2.73886 +487 1 18.4725 11.4275 14.8977 -1.36673 1.10287 -33.3787 +488 2 18.0559 11.937 14.1605 1.63397 -11.827 9.6186 +489 2 18.3384 12.0011 15.6307 -5.5196 20.2825 24.8766 +490 1 7.17852 9.29091 7.31266 -12.1778 -5.70725 -5.55247 +491 2 6.76293 8.42612 7.50122 5.49043 12.248 4.67896 +492 2 8.1168 9.11866 7.26453 10.5183 -1.31775 0.108346 +493 1 18.3399 15.3762 12.1294 6.77425 7.85663 0.444206 +494 2 0.624383 15.5788 11.9067 -6.5428 -1.83873 1.38378 +495 2 17.7957 15.9125 11.5264 -1.63248 -5.99386 0.103645 +496 1 16.5386 4.34911 5.2503 -38.2238 -21.0357 51.9327 +497 2 16.6701 3.96728 6.16388 -6.69454 12.6485 -26.055 +498 2 17.3775 4.32019 4.85382 41.1543 5.3392 -22.1831 +499 1 17.7341 3.08223 10.7755 -2.39486 19.3144 10.8573 +500 2 18.6554 3.32717 10.9901 -9.67157 -6.39923 -2.68969 +501 2 17.7406 2.18791 10.4534 3.10102 -17.6187 -9.33289 +502 1 12.3347 18.6584 10.1394 22.1152 -18.6094 -11.1242 +503 2 11.4269 0.285024 10.28 -5.50333 15.1479 5.74269 +504 2 12.9381 0.769801 10.2484 -7.53185 0.18177 2.36971 +505 1 10.4414 9.72052 12.5804 5.49259 18.5488 2.65475 +506 2 11.2372 9.86145 13.1232 -3.33328 -5.81976 -2.33485 +507 2 10.4983 8.8205 12.2639 -0.9125 -13.8337 3.2089 +508 1 0.576047 2.60181 7.2501 -1.65995 13.3288 -12.3458 +509 2 0.268028 3.48996 7.49944 2.28387 -7.91724 -1.96879 +510 2 1.05133 2.26453 8.01425 -2.57801 -1.32252 3.73717 +511 1 0.35756 15.2681 6.96461 -6.18578 -18.242 -64.2832 +512 2 0.656709 14.9904 7.8095 9.46814 -3.47663 35.1726 +513 2 0.533918 14.474 6.37104 -3.56161 26.9089 25.8891 +514 1 17.0554 6.8805 14.912 24.4713 -1.83906 11.5387 +515 2 17.8121 7.50971 14.9246 -13.4777 -6.95308 -2.51376 +516 2 17.3666 6.12061 15.452 -8.01529 8.59931 -8.57008 +517 1 9.11821 12.4896 7.9597 -39.3936 14.7629 -4.46817 +518 2 9.45619 11.6923 7.5591 7.68398 -14.1787 -12.8233 +519 2 8.20522 12.6235 7.56541 34.2702 -5.52337 13.9854 +520 1 1.14934 1.62531 2.7512 -10.6975 -16.4856 11.3042 +521 2 0.557887 1.95566 2.07466 1.95024 15.5996 -8.59751 +522 2 1.5216 2.35039 3.25303 6.14281 9.13632 1.51194 +523 1 4.18801 15.1235 9.83797 -4.3571 13.9944 -8.49019 +524 2 4.15169 15.4364 8.91421 -7.63033 -5.74015 13.5827 +525 2 5.04261 14.6826 9.83518 3.69587 -3.91806 9.7151 +526 1 7.38616 2.29059 14.8987 -4.38475 3.80451 -15.2317 +527 2 7.23636 1.51405 14.3418 -1.55041 0.530275 6.25745 +528 2 7.45512 3.02747 14.2682 8.09838 -6.66607 2.4433 +529 1 18.2954 14.5248 2.13868 21.7335 16.5649 1.154 +530 2 0.530315 14.9412 2.32201 -13.6123 -15.8317 -3.76049 +531 2 17.7186 15.2797 1.96871 -6.10103 1.83177 1.59348 +532 1 10.0818 2.68123 12.8993 0.213282 -13.011 -16.4533 +533 2 9.9804 2.00538 12.1749 2.58274 17.6757 17.7308 +534 2 9.30115 3.24961 12.8455 -1.77409 -0.0668197 -1.90377 +535 1 2.92042 8.79199 13.1038 3.60331 12.5418 -6.85933 +536 2 3.19747 9.71233 12.8787 -2.51528 -19.5049 2.84802 +537 2 3.74925 8.3139 13.2755 -6.12566 -1.47569 1.35688 +538 1 3.2826 8.6043 3.78787 -1.06696 -30.5523 53.3514 +539 2 3.6648 9.24286 3.23576 21.5217 31.7748 -30.2126 +540 2 3.73659 8.75462 4.6619 -18.3855 -4.45548 -24.3241 +541 1 5.99503 7.23605 8.68049 -5.70462 -6.01689 -7.52618 +542 2 5.88732 6.32464 8.37432 -5.09887 -1.13221 5.21957 +543 2 5.15444 7.50455 9.08765 4.58913 -3.02319 1.70333 +544 1 14.8694 1.67632 1.824 4.95495 -3.07302 -21.4612 +545 2 14.923 2.54765 2.20438 -6.9063 6.82762 18.8127 +546 2 15.1986 1.83723 0.92353 -1.55356 -7.84532 7.79991 +547 1 8.71318 14.9586 0.633889 5.3189 4.72704 12.5337 +548 2 9.41548 15.0137 1.3229 -12.9747 -8.59069 -7.21106 +549 2 7.9574 14.4505 1.00218 9.17218 5.81258 0.251254 +550 1 15.3522 1.50057 7.22863 -1.61242 -14.2743 -3.26221 +551 2 14.7819 0.961058 6.63945 7.54361 11.5891 10.8038 +552 2 14.804 2.18796 7.6304 -1.95204 4.928 -5.75504 +553 1 4.88832 12.8638 18.4669 14.1773 6.076 10.5021 +554 2 5.16486 12.9634 0.754115 -2.57074 -3.9589 -10.7447 +555 2 5.64539 13.2163 17.9734 -6.87045 1.01425 -0.872896 +556 1 15.3658 8.71105 18.1022 0.313753 1.99863 -15.4271 +557 2 15.6825 9.25538 17.3367 -2.33671 -6.91366 23.9636 +558 2 15.2177 9.29821 0.21527 -1.89476 6.92048 -0.597105 +559 1 12.0025 3.14868 18.2874 -4.08601 9.85731 -2.22671 +560 2 12.1144 3.11564 0.603374 4.33643 -8.86024 -4.9595 +561 2 12.4653 2.40747 17.863 0.0624807 -1.52737 7.22507 +562 1 13.2135 12.7035 5.12884 9.73413 0.384952 2.90661 +563 2 13.7 11.8654 5.00774 -9.98906 4.00813 0.0328844 +564 2 13.4141 12.9701 6.04548 -3.79483 -4.91087 -6.97232 +565 1 6.18903 7.09371 0.234798 3.60985 -26.8596 -14.0682 +566 2 6.2071 8.04594 18.8061 -7.0012 19.4313 6.00448 +567 2 5.26363 6.79856 0.279731 4.49735 8.94005 5.55961 +568 1 17.7003 15.89 14.853 -18.1963 11.2058 -20.3772 +569 2 16.8346 16.3247 14.8039 6.19322 -4.54728 12.6057 +570 2 17.8435 15.7325 13.9057 13.4875 -6.37623 4.18836 +571 1 13.0834 0.870867 16.8965 -0.161813 1.3846 -1.86612 +572 2 14.0072 0.582211 16.892 1.10768 1.72224 0.871652 +573 2 12.5754 18.726 16.653 1.71204 -0.315799 1.62538 +574 1 10.8945 14.507 7.48359 31.9827 12.7774 -14.5262 +575 2 10.2535 13.8684 7.76101 -18.1255 -14.8352 9.6937 +576 2 11.748 14.0397 7.49435 -7.74827 -1.48019 1.36014 +577 1 17.7521 8.40099 2.11802 -4.68381 10.101 13.2464 +578 2 16.8759 8.32923 2.50971 -7.38706 6.94009 5.95596 +579 2 17.7532 7.67887 1.5098 2.25561 -17.6604 -22.6471 +580 1 12.5231 7.84865 2.0094 -2.30264 15.9804 1.37474 +581 2 12.1379 8.74758 1.97393 9.3167 -10.0751 -1.70323 +582 2 12.325 7.4571 1.14918 -4.66948 -5.90928 2.89896 +583 1 11.972 14.5025 10.3451 -2.96888 12.9379 -2.77484 +584 2 12.1874 14.7132 9.42348 -1.74009 -6.18971 10.5862 +585 2 11.0277 14.706 10.4449 2.87573 -2.36207 -4.30421 +586 1 6.71227 6.84952 15.5806 25.6498 -3.78319 22.6581 +587 2 7.68828 6.90632 15.3859 -23.8939 0.442938 5.1849 +588 2 6.62279 7.02219 16.5478 -0.830995 -1.23763 -22.0679 +589 1 7.92027 4.40739 13.1357 7.88731 17.7005 28.4833 +590 2 7.20639 4.70613 12.563 -5.96959 3.19417 -4.54574 +591 2 8.05118 5.13552 13.7952 -2.84521 -16.8776 -20.7331 +592 1 13.2899 12.2294 14.3537 -3.3223 6.18653 6.3482 +593 2 12.9901 11.3268 14.1873 4.87208 -4.78833 3.90165 +594 2 13.6879 12.5058 13.5223 1.91273 0.0234059 -4.06458 +595 1 14.5389 9.51264 7.32918 -7.01434 -27.1539 -11.6023 +596 2 15.2763 10.0624 7.53312 20.4851 16.6908 8.43718 +597 2 13.8132 9.80854 7.861 -14.3264 8.19434 11.2695 +598 1 12.68 16.8773 3.29092 2.11558 25.6431 -8.94229 +599 2 12.7733 17.3894 4.13219 -1.2803 -9.72294 -18.9636 +600 2 12.6793 17.5234 2.53176 -0.650571 -10.0569 23.6182 +601 1 0.970813 7.05439 17.3478 19.6691 8.71735 -9.44801 +602 2 0.0997442 7.2771 17.6294 -27.888 -7.65058 15.2547 +603 2 1.07493 7.61203 16.5711 5.30897 3.90939 -5.98442 +604 1 13.0218 4.86702 15.7977 -14.5255 -22.5737 -0.430567 +605 2 13.6652 4.12206 15.7771 -2.73243 23.3382 0.768668 +606 2 13.4898 5.70142 15.8866 10.098 7.61534 -0.732483 +607 1 2.35004 3.40025 5.07686 -12.6408 -17.529 -7.45963 +608 2 1.84891 3.15034 5.87751 4.27568 5.0167 -3.29201 +609 2 2.74325 4.26374 5.21682 1.23402 6.29722 12.7184 +610 1 8.14417 10.9001 13.7499 9.28616 -30.1931 45.6744 +611 2 7.9506 10.3552 14.611 8.46781 36.9232 -44.8577 +612 2 9.00813 10.5574 13.4404 -10.6035 2.99953 -2.14266 +613 1 13.0821 1.49083 13.2989 5.3891 9.28887 -24.1834 +614 2 13.7872 1.3627 12.5959 -25.8284 12.5052 17.3021 +615 2 12.4896 2.22352 12.9857 19.0093 -19.6589 8.86348 +616 1 6.62484 13.6674 2.02561 -2.30013 1.61314 -5.1998 +617 2 5.94206 14.1599 2.51404 7.05284 -6.38204 5.2583 +618 2 7.12137 13.1184 2.65568 -4.11309 1.61678 2.96157 +619 1 15.7857 6.33001 12.4874 9.47505 -1.37582 18.5865 +620 2 16.2809 6.76838 11.7933 3.97273 7.7159 -2.96061 +621 2 16.3586 6.41799 13.2831 -12.689 -0.09302 -8.30077 +622 1 16.7471 0.613682 9.52771 11.5447 -14.6629 17.7173 +623 2 16.7567 18.2848 9.57147 -3.7535 4.88819 4.87116 +624 2 16.43 0.840462 8.66213 -13.2327 5.78697 -22.1845 +625 1 6.19152 11.681 8.24955 3.80355 -8.99636 -2.81467 +626 2 5.36879 11.4903 8.73023 3.19436 -10.2741 -4.0588 +627 2 6.55865 10.8405 7.8788 -10.8203 9.76695 14.653 +628 1 2.78766 8.56788 0.409413 -52.7319 2.11899 -11.855 +629 2 2.08185 8.03903 18.552 32.3713 20.2249 14.5342 +630 2 2.26775 9.27739 0.866586 13.6595 -12.5773 -9.56289 +631 1 10.1003 10.2385 6.61376 -10.8952 5.58665 6.62413 +632 2 10.4921 9.47201 7.04387 8.70092 -2.05853 1.95229 +633 2 10.597 10.3787 5.79806 -1.31095 -2.00825 -0.431677 +634 1 6.84539 15.7603 6.76774 -1.32488 -8.5888 0.285168 +635 2 7.15445 16.2386 7.5582 -1.07119 -0.859265 -6.52036 +636 2 7.16186 16.249 5.99512 -0.908646 8.8198 -0.167177 +637 1 6.64088 12.8596 5.99362 6.27305 7.11444 -12.0385 +638 2 6.74407 13.8044 6.07603 1.27228 12.7365 2.69296 +639 2 6.25078 12.5941 6.82297 -5.96354 -7.18103 4.5408 +640 1 16.6867 12.5722 9.84379 -3.64815 -5.06409 7.40683 +641 2 16.7505 11.8965 9.15556 3.82735 1.49832 -4.74998 +642 2 16.8024 13.43 9.4304 0.212763 1.2752 -2.86494 +643 1 6.31521 2.74143 2.73106 -6.87016 -8.03266 -4.4066 +644 2 6.55003 3.64872 2.52358 -0.655364 10.9132 -0.0341781 +645 2 5.98199 2.35933 1.9027 -1.39596 -0.0669143 5.2552 +646 1 10.642 2.89265 3.25205 -8.44131 -1.48195 -5.66324 +647 2 10.1183 3.68518 3.4139 4.92295 3.00907 1.37692 +648 2 10.2968 2.53281 2.41595 2.77965 2.00448 3.56419 diff --git a/examples/amoeba/dump.water_box.hippo.1.test b/examples/amoeba/dump.water_box.hippo.1.test new file mode 100644 index 0000000000..33463a3a5d --- /dev/null +++ b/examples/amoeba/dump.water_box.hippo.1.test @@ -0,0 +1,7227 @@ +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.67966 7.08769 17.9461 -19.3527 -13.639 6.25201 +2 2 7.80945 6.75579 18.2607 18.4949 11.1596 -6.01922 +3 2 8.72223 6.81424 17.0254 5.85599 -0.890166 3.45586 +4 1 18.5257 8.24445 6.83762 11.8085 12.5587 58.8481 +5 2 0.216892 7.89544 6.05003 10.8935 -14.9684 -50.5046 +6 2 0.444268 7.82601 7.5302 -15.2958 7.9793 -8.89884 +7 1 8.37906 18.5504 6.81463 25.5385 6.64228 -3.75624 +8 2 9.34042 0.098069 6.73406 -20.9151 -2.68951 1.38711 +9 2 7.93962 0.573676 6.26984 -0.656308 -0.308718 3.40946 +10 1 6.58995 1.84432 11.7198 46.6828 -15.9611 -12.5859 +11 2 5.88543 2.40231 11.9251 -37.6261 28.8114 18.1934 +12 2 6.18153 1.06275 11.3693 -6.58868 -16.6156 -5.55691 +13 1 7.1466 5.75358 2.33152 -56.1364 42.5085 -2.61462 +14 2 6.36812 6.12603 2.86268 40.1937 -23.4301 -4.21826 +15 2 7.02502 6.29465 1.5182 16.3021 -20.7884 10.9258 +16 1 16.2164 10.1388 16.1382 -32.0875 21.5958 16.7579 +17 2 16.9509 10.2747 15.5847 32.9015 -1.03241 -20.1636 +18 2 15.8498 11.0405 16.2399 1.98783 -14.756 2.71439 +19 1 10.6046 15.0374 2.30369 -8.13409 -25.494 -7.18668 +20 2 10.5292 14.3949 3.01849 1.41683 -0.603724 2.75561 +21 2 11.0236 15.78 2.70962 11.6057 19.8833 4.5888 +22 1 17.1624 8.24409 10.3708 13.0676 7.07862 9.73504 +23 2 16.5528 8.68798 10.966 -4.65968 7.37974 1.83434 +24 2 17.9421 8.82333 10.3208 -6.34155 -10.1937 -2.20396 +25 1 14.901 15.8652 16.3167 18.01 -6.87509 18.5636 +26 2 14.0225 16.1982 16.2525 -26.9236 12.7201 -6.50875 +27 2 14.9141 15.482 17.2099 2.63751 -6.05913 -7.59706 +28 1 12.1752 13.3771 0.408263 -11.3168 6.26442 9.98381 +29 2 12.0579 13.8465 18.23 5.67057 -4.50268 -16.0578 +30 2 11.6217 13.8904 1.00796 3.42507 -1.00312 9.73088 +31 1 9.27358 5.34243 4.05546 -35.2781 32.5984 16.8393 +32 2 8.64594 5.4665 4.83764 28.3783 -16.8163 -28.778 +33 2 8.74177 5.68615 3.30282 7.52493 -14.9247 9.48156 +34 1 1.83016 4.27673 11.6495 -21.1764 37.5598 -8.14901 +35 2 1.70328 5.22377 11.9391 6.02814 -28.7768 -8.29565 +36 2 2.40811 3.85345 12.2597 13.4728 -11.3181 18.3421 +37 1 1.96438 6.83299 8.3731 -11.1902 3.43717 -25.3738 +38 2 2.49614 7.21578 9.0563 9.35281 -0.190165 18.6039 +39 2 1.81128 5.90585 8.57354 7.84101 -3.79534 5.21373 +40 1 5.40557 4.38899 7.93274 -6.81526 4.7224 -2.63907 +41 2 5.53738 3.43895 7.78131 -7.79962 9.88898 0.533881 +42 2 4.75516 4.73491 7.29062 10.7858 -16.238 7.24535 +43 1 3.23 2.92842 17.5524 -0.538114 20.9936 16.7312 +44 2 3.93109 3.19827 16.9402 -0.965509 8.21721 4.01649 +45 2 3.00444 3.70897 18.1497 6.13449 -29.114 -23.6081 +46 1 7.4624 5.26283 6.13117 9.12728 4.25284 -1.73168 +47 2 8.02565 5.58849 6.88177 -24.817 -14.4341 -14.6054 +48 2 6.93508 4.45577 6.3254 16.0496 22.0303 12.0173 +49 1 9.77896 7.02384 11.9834 11.1205 -3.87253 23.9446 +50 2 10.2721 6.37256 11.5011 10.9222 -10.0302 -1.39678 +51 2 9.1532 7.31587 11.3499 -23.6433 13.1239 -20.7784 +52 1 14.1167 3.54999 8.03003 -30.7601 -1.60704 -37.9113 +53 2 13.4732 4.22413 7.73132 15.1608 -10.723 4.30178 +54 2 14.3809 3.80189 8.88487 12.8065 16.1495 34.678 +55 1 4.82329 17.2568 4.03846 -17.85 32.0436 -31.4073 +56 2 5.49315 17.973 4.01308 -7.71314 -24.6342 10.4391 +57 2 4.18746 17.5412 3.33843 10.9703 -13.5421 12.8553 +58 1 16.4918 16.6259 10.0493 29.9016 15.3745 -40.7533 +59 2 16.1673 16.3226 10.8594 -24.6786 -13.0437 37.8908 +60 2 15.9925 16.2084 9.33562 -4.01544 -1.82242 7.63759 +61 1 1.94489 4.93323 0.49791 29.1886 10.4759 3.59715 +62 2 2.55322 5.26335 1.2053 -17.2324 -10.4098 -15.9422 +63 2 2.08253 5.591 18.4408 -14.7087 -3.80383 3.81857 +64 1 11.816 13.3571 16.2711 -7.8083 1.12937 6.2001 +65 2 11.2371 12.6203 16.5671 13.3708 1.96491 -16.2063 +66 2 12.2446 13.1893 15.4079 -11.197 -7.32732 11.8633 +67 1 10.105 11.0651 16.9545 16.7158 -32.7784 1.37979 +68 2 10.5674 10.1947 17.1295 -14.0823 30.097 -5.45833 +69 2 9.25349 10.8067 16.5912 -2.99511 2.11526 2.57572 +70 1 11.7264 17.5421 13.4742 2.50122 -25.0158 -11.214 +71 2 12.2771 16.9836 12.8968 -8.91486 0.79877 6.23222 +72 2 12.1041 18.3936 13.317 1.59091 22.4782 2.42571 +73 1 6.33029 9.31911 12.2264 15.6898 -25.4439 -25.1534 +74 2 7.02603 8.96242 11.6353 -17.823 2.07037 1.33758 +75 2 6.81249 9.95941 12.7172 5.93051 22.1649 19.4162 +76 1 16.2187 12.7249 2.70186 -8.69715 -37.3569 7.82337 +77 2 17.0292 13.1566 2.50302 19.6243 18.7999 -9.68795 +78 2 15.4982 13.3357 2.61812 -8.61102 21.6356 1.57727 +79 1 0.637202 12.5625 5.84914 -32.6687 7.10288 -2.13707 +80 2 0.892312 12.5507 4.90771 -4.51242 -1.40786 13.4578 +81 2 18.3039 12.804 5.85329 37.5994 -4.88925 -6.97833 +82 1 5.19922 16.3781 18.5047 -7.71264 -0.634541 -12.9921 +83 2 5.80284 15.8543 17.9455 2.11468 10.7978 13.7187 +84 2 5.67034 16.9636 0.462296 7.23142 -5.58048 -3.24093 +85 1 0.510145 7.62945 4.0545 45.851 19.5686 -25.4796 +86 2 18.5719 8.14656 3.45296 9.61971 -16.7838 10.3831 +87 2 1.46496 7.74082 3.66917 -52.3954 -1.94356 25.3273 +88 1 3.14672 8.89584 6.52626 -54.2957 5.34018 -1.73828 +89 2 3.50609 8.59991 7.35294 9.18701 -2.26398 8.55435 +90 2 2.14573 8.92962 6.68203 45.3688 -0.563656 -9.64228 +91 1 7.30854 10.3037 16.1717 -0.0267506 0.140778 15.7468 +92 2 6.56213 10.4624 15.5802 1.32412 -0.384411 10.7132 +93 2 6.99303 10.278 17.1118 0.130505 3.94788 -23.0495 +94 1 11.1122 1.06968 4.98939 -2.83136 -16.8604 13.0177 +95 2 11.0776 1.97142 4.64864 2.2702 -4.31387 -11.6367 +96 2 10.7048 0.433547 4.37027 2.96408 14.9419 -2.56144 +97 1 4.45204 2.70061 13.2052 -8.32298 -31.9478 35.5434 +98 2 4.60333 3.05865 14.0914 -0.476624 15.5497 -15.2927 +99 2 4.38645 1.737 13.4626 0.207127 24.1129 -25.2696 +100 1 8.42792 10.0237 1.78469 -10.6267 -17.9408 16.848 +101 2 8.3405 10.6377 2.53622 4.43246 -2.98222 -4.40025 +102 2 8.49672 9.11244 2.17467 4.60711 29.3182 -9.45134 +103 1 10.5335 1.75383 15.546 -31.9958 -1.22726 0.532554 +104 2 11.3977 1.82718 15.9216 23.4057 -5.242 -0.0927752 +105 2 10.5608 1.78317 14.5837 3.34522 3.38855 0.282019 +106 1 2.77693 12.941 7.74821 -10.6415 2.34425 -2.27994 +107 2 3.28797 13.5733 7.23382 5.58977 0.334345 4.09149 +108 2 1.98704 12.8256 7.20013 5.22386 -8.52712 2.54059 +109 1 3.63517 11.6895 5.33963 -10.2259 -13.0028 -10.3717 +110 2 3.35385 11.0502 6.03137 4.73753 15.317 -16.6328 +111 2 2.8758 11.855 4.74058 11.3048 -4.09559 12.5928 +112 1 6.88803 14.474 16.8428 -13.42 9.46677 6.94107 +113 2 7.55973 13.8293 16.6383 4.5229 -1.76969 -1.40507 +114 2 6.60381 14.8838 16.0165 0.0834179 -9.06129 -0.120708 +115 1 14.1722 14.5374 3.41536 20.1951 -3.19134 -21.8839 +116 2 13.6514 15.2845 3.14096 -9.23852 13.3738 0.77613 +117 2 13.8512 14.2508 4.25439 -13.5451 -9.47926 16.7085 +118 1 8.28226 18.1809 16.0824 -9.43856 -15.6135 -5.07226 +119 2 8.77677 17.3494 16.3071 1.43839 31.5077 -5.33478 +120 2 8.7603 0.384816 15.9919 11.1327 -19.5096 4.24776 +121 1 4.73724 1.61643 4.90111 5.86874 37.6921 -30.6753 +122 2 3.96969 2.16837 5.15263 9.12039 -10.9712 -6.28456 +123 2 5.18465 2.1484 4.15475 -17.6049 -26.8232 41.7187 +124 1 15.1457 12.8616 16.4403 -17.0638 -11.2899 43.408 +125 2 14.6041 12.8692 17.2613 22.7365 8.03356 -12.6578 +126 2 14.49 12.6307 15.8136 -17.0236 -4.89604 -35.7974 +127 1 15.779 18.3837 16.786 48.5063 8.0766 44.3104 +128 2 16.5108 18.615 17.4688 -41.9285 -7.99937 -34.0327 +129 2 15.7694 17.4186 16.7687 -10.3466 2.2793 -1.1406 +130 1 1.1383 1.1331 16.5571 -3.54071 10.9478 5.94974 +131 2 1.96551 1.50352 16.9177 -15.9767 0.55296 -3.51275 +132 2 0.420521 1.53444 17.0916 21.5279 -7.8795 -5.43288 +133 1 18.0817 4.5907 15.863 15.8138 -19.1991 -2.64562 +134 2 18.5818 3.91936 15.3489 -11.6552 16.5822 9.8521 +135 2 18.5602 4.7339 16.6874 -1.16116 -1.56098 -3.02727 +136 1 12.22 16.9378 16.1148 -9.97587 -12.4224 57.0196 +137 2 11.409 16.6934 16.6676 29.0172 6.05041 -31.7989 +138 2 11.9646 17.3216 15.2917 -14.4882 2.9648 -22.1743 +139 1 15.8709 2.55221 17.9707 -3.56258 26.452 -16.7944 +140 2 15.7355 3.48355 18.2574 6.35046 -25.5765 3.86241 +141 2 15.6659 2.59235 17.0072 6.0189 -6.56803 19.8103 +142 1 6.70868 13.791 10.2637 1.94011 22.9489 3.02058 +143 2 6.59347 13.548 11.1958 0.710608 -4.45224 -7.92394 +144 2 6.58252 13.0514 9.6765 -3.73143 -16.591 0.344408 +145 1 10.146 18.2027 2.80372 16.894 35.9 -12.6825 +146 2 10.2207 0.331961 2.18345 -1.03174 -23.6422 14.9845 +147 2 9.26571 17.8868 2.67703 -18.7462 -7.34721 -7.1199 +148 1 2.97538 17.748 6.06078 -27.2244 1.77787 1.96995 +149 2 2.09399 17.6473 5.67013 1.23544 -3.46851 16.5241 +150 2 3.45883 17.8838 5.26396 32.1509 0.10025 -8.47089 +151 1 12.558 17.0134 7.97028 2.72879 -14.1128 -3.91884 +152 2 11.9572 16.2512 7.82085 4.20569 13.3061 15.6125 +153 2 12.4657 17.4524 8.83591 -10.4039 -6.95813 -9.08653 +154 1 14.8795 15.2862 8.28544 5.56082 -19.5077 38.9848 +155 2 13.9824 15.6136 8.40666 -1.04882 8.68143 -14.5015 +156 2 15.2312 15.4641 7.43118 2.2507 10.8701 -29.8329 +157 1 17.5429 18.3228 0.375372 -51.3852 -2.4253 -14.1847 +158 2 18.116 17.6308 0.128652 38.5367 -21.5025 -8.63787 +159 2 17.9698 0.288559 0.934677 24.3068 21.4661 19.9837 +160 1 0.910209 10.3712 1.41143 -2.71779 -52.992 43.3073 +161 2 0.158544 9.88347 1.87089 22.0109 19.7614 -26.7074 +162 2 0.565924 11.0969 0.944383 -22.7833 34.6337 -23.5778 +163 1 1.55407 12.175 3.31087 16.6578 22.9783 50.8488 +164 2 1.36245 11.4802 2.72234 -7.70692 -21.3552 -33.2695 +165 2 1.61623 13.0206 2.87285 -0.913798 3.83337 -14.7861 +166 1 0.543127 17.2543 4.88609 29.8094 34.6465 -52.7559 +167 2 0.11032 17.9772 5.31124 -19.8915 12.2203 12.8491 +168 2 0.420366 16.4266 5.2673 -10.0988 -43.8479 36.8786 +169 1 1.10053 1.01949 9.38768 20.7334 -4.84081 3.89797 +170 2 1.46081 0.575286 10.1589 7.03147 5.77442 11.7732 +171 2 0.265613 0.594128 9.34525 -29.6063 -3.3853 -10.3011 +172 1 16.8007 2.32783 13.2877 6.1037 15.2386 -31.0559 +173 2 17.0701 2.57314 12.3549 -10.0746 -10.076 30.4228 +174 2 16.4263 1.43993 13.282 1.60122 -3.62923 0.222317 +175 1 2.45231 15.8283 12.1942 27.8718 -10.8871 18.2649 +176 2 2.8623 15.5513 13.0537 -9.1784 7.03247 -27.4702 +177 2 2.91392 15.3801 11.4615 -3.34054 6.42182 7.24567 +178 1 16.435 15.531 5.9458 21.7194 38.3058 -21.2998 +179 2 17.3808 15.5177 6.20547 -16.0791 -6.59953 3.69269 +180 2 16.4147 16.2211 5.22063 -10.9707 -19.0563 26.084 +181 1 5.84547 5.02056 11.8065 15.5941 -20.7973 -13.2046 +182 2 5.55799 5.91374 11.8891 -11.5246 18.633 11.9833 +183 2 5.09 4.45915 11.9819 -3.94875 -1.81326 3.16792 +184 1 15.2214 4.86555 0.731755 -13.7826 -16.8748 28.0949 +185 2 14.6776 4.45845 1.47821 23.1081 18.7106 -26.9415 +186 2 14.6696 4.95834 18.5986 -11.4435 4.17379 2.92627 +187 1 16.3401 16.2933 2.11217 18.5695 -12.4905 -31.3072 +188 2 16.0666 16.7695 2.87319 -12.4192 21.1701 22.1863 +189 2 16.7601 16.9279 1.50378 -10.9162 -1.12869 10.7347 +190 1 0.305885 4.87877 3.79118 -7.51195 53.5881 20.4451 +191 2 0.299338 5.85541 4.09758 -3.10789 -46.5114 -24.0825 +192 2 1.16991 4.5635 4.03062 6.84312 -11.1831 1.05233 +193 1 2.92501 14.9782 15.0356 -4.41813 7.08234 41.1019 +194 2 3.0159 14.7264 15.9987 0.986861 -4.57119 -32.7424 +195 2 2.35392 15.7535 15.1247 6.41577 5.11218 -9.25191 +196 1 1.1115 14.5727 9.55731 53.3594 20.601 -11.7192 +197 2 2.08491 14.4157 9.46275 -24.0912 20.2308 -9.17401 +198 2 0.897072 13.7408 9.90248 -29.0631 -35.5955 19.1061 +199 1 13.6501 16.6688 11.5433 6.78983 17.7214 -9.74398 +200 2 13.4697 17.4567 10.9694 -2.9322 -22.903 16.7504 +201 2 13.5721 15.8897 10.9842 -10.359 0.342192 0.0202177 +202 1 4.73098 1.47842 0.720986 -5.29759 -7.25447 0.0447572 +203 2 4.27169 1.98826 0.034225 -5.56193 -3.14325 9.7343 +204 2 4.11741 0.788607 1.06182 6.25861 16.2271 -3.37713 +205 1 1.42158 18.4663 11.9139 -14.0127 27.0043 -17.9914 +206 2 1.21766 0.394331 12.6648 1.7087 -1.58128 0.41261 +207 2 1.94844 17.765 12.2423 13.0376 -22.9613 11.2697 +208 1 11.5498 10.1018 4.11619 27.4262 20.5676 -21.0421 +209 2 11.5687 10.5955 3.24216 -3.20948 -18.7647 28.9446 +210 2 12.4899 10.1059 4.45555 -29.515 -1.53007 -14.7279 +211 1 8.38254 12.182 3.76573 -26.3924 1.04105 6.81072 +212 2 9.25863 12.501 4.06076 -19.5654 3.48754 6.33549 +213 2 7.63736 12.4251 4.40785 41.4561 -5.4387 -17.0092 +214 1 14.3228 4.03714 3.29709 11.5996 0.889358 18.0886 +215 2 14.8928 4.14179 4.10547 -12.6664 -0.432988 -23.901 +216 2 13.4701 4.45558 3.48891 5.46089 -2.24129 3.2962 +217 1 5.58188 1.78199 7.50513 -33.666 -46.5708 42.0626 +218 2 5.0172 1.13958 8.12095 34.1345 40.5367 -42.64 +219 2 5.33078 1.59122 6.59529 1.4651 -1.13721 -3.53311 +220 1 17.9086 1.12503 4.88467 5.13037 -2.27617 -10.7476 +221 2 18.4038 1.54032 4.14207 -7.55128 -2.38968 19.1857 +222 2 17.6814 1.78344 5.55455 5.62983 -0.00428508 -6.93418 +223 1 6.83101 9.39303 4.49716 -12.9019 3.06885 -29.4929 +224 2 6.83675 9.57499 5.42715 5.2276 -1.57178 18.8103 +225 2 7.66807 8.99049 4.24996 8.60683 3.06936 7.19189 +226 1 2.71406 14.9654 1.962 -12.6433 -7.2797 -26.4735 +227 2 3.33343 14.7912 2.66354 11.3685 -5.36414 4.18623 +228 2 3.09502 14.6645 1.10257 -3.50464 10.9487 24.1748 +229 1 17.279 12.8803 13.1283 -18.5839 20.1434 9.0108 +230 2 16.4044 13.2339 13.3283 -9.51346 -21.2442 0.20606 +231 2 17.6948 13.7346 13.0834 29.6252 3.29486 -10.2855 +232 1 15.0196 10.5818 1.38314 -38.8036 -34.5801 -31.952 +233 2 15.5102 11.1963 1.85791 33.5109 39.8843 28.1173 +234 2 14.3351 11.0964 0.933298 4.14202 -6.46403 5.49191 +235 1 5.71789 6.95838 4.52856 4.11089 -29.6335 9.96606 +236 2 5.85266 7.87985 4.34179 3.17266 16.1428 1.23553 +237 2 6.44364 6.70841 5.13514 -12.5329 -0.461157 -7.94794 +238 1 8.12142 8.26262 10.159 -0.855146 6.49391 46.4818 +239 2 8.58519 8.93965 9.66877 4.4396 1.59282 -10.2318 +240 2 7.56021 7.74854 9.59836 -7.32825 -5.6782 -22.3885 +241 1 13.5311 18.2901 5.8079 -14.4364 -13.815 12.5854 +242 2 12.703 0.102298 5.56963 8.23181 2.14052 6.61043 +243 2 13.2939 17.6289 6.50758 2.60691 23.7973 -17.1373 +244 1 0.327324 2.56344 0.113251 2.62118 15.3541 1.11187 +245 2 18.009 2.52214 18.5736 10.3638 17.1812 4.70476 +246 2 0.724331 3.48299 0.160564 -23.8753 -26.7718 -0.881277 +247 1 12.6396 10.9599 9.76875 -60.0152 14.8867 -10.4701 +248 2 11.6552 10.7306 9.75031 40.0232 26.8927 -4.84212 +249 2 12.944 10.1383 10.0842 28.9404 -31.8014 10.6031 +250 1 0.789377 12.2851 11.08 12.3121 4.77193 16.7259 +251 2 18.4919 12.3017 11.2021 -18.2956 -1.72231 -7.06107 +252 2 1.09088 12.7637 11.8722 5.11265 -11.1183 -7.6011 +253 1 5.04567 7.2193 13.4912 -20.9717 -2.87687 -14.2941 +254 2 5.59899 7.84649 13.0247 8.94565 11.9067 4.64647 +255 2 5.48047 6.97898 14.3058 11.2978 1.34955 6.76892 +256 1 1.28609 6.99027 11.837 -50.3798 -70.0072 -12.7986 +257 2 0.481329 7.14037 11.2978 16.1889 0.462756 10.6855 +258 2 1.71601 7.79102 11.8803 28.8555 60.7949 7.07409 +259 1 15.4442 9.46712 12.3088 17.5488 35.5581 30.8368 +260 2 15.6103 10.4448 12.4444 -11.4156 -32.7422 -13.7105 +261 2 15.5582 9.10301 13.208 -6.0251 -0.167312 -17.6616 +262 1 16.6404 12.9744 5.44078 -0.477448 -16.7093 5.71929 +263 2 16.2955 13.8866 5.54247 6.71099 -18.3284 -17.4666 +264 2 16.51 12.593 4.54035 -5.5475 22.5864 15.6708 +265 1 6.17495 10.0683 0.210584 -22.0037 -7.52033 -29.8636 +266 2 5.35839 10.4511 0.557392 5.20282 -1.85407 -1.83494 +267 2 6.76092 10.0813 0.943985 23.8798 0.550264 15.5383 +268 1 12.3644 6.05734 4.04236 -20.6788 -35.4367 28.6454 +269 2 12.4738 6.70802 3.38308 -3.94744 31.282 -24.9442 +270 2 11.4212 5.77124 4.03221 20.7152 8.11174 -1.23853 +271 1 0.124733 12.8266 0.203961 1.72956 2.54106 -4.3392 +272 2 0.029974 13.5935 0.786871 -3.06107 -4.47794 0.0529132 +273 2 18.185 12.9963 18.0877 7.84157 1.57112 5.96497 +274 1 3.83931 18.5785 8.61972 17.9182 -8.56599 -14.1766 +275 2 3.58625 18.36 7.70531 -6.70328 -0.941099 8.10721 +276 2 3.07994 0.282626 9.06556 -18.5101 7.20519 -0.527908 +277 1 7.37599 17.2741 4.45241 45.8101 34.7343 -2.7797 +278 2 8.02493 17.9603 4.76808 -26.0663 -25.3607 -1.65849 +279 2 7.47725 17.3636 3.49301 -12.8678 -9.31687 6.18264 +280 1 9.20909 17.0315 12.2197 44.1268 -5.71549 17.0535 +281 2 9.48765 16.172 11.8421 -16.3435 15.6721 -2.29993 +282 2 9.99892 17.2887 12.7762 -25.7988 -5.61825 -13.0657 +283 1 13.3284 13.0292 7.94175 -52.6762 -33.6944 -6.73328 +284 2 13.0533 12.253 8.47808 14.3801 9.17086 -2.06391 +285 2 14.1985 13.2855 8.14946 32.3912 12.3835 13.183 +286 1 14.9871 2.94126 15.3478 14.7752 10.8142 -9.8874 +287 2 14.2243 2.52816 14.9303 6.27209 -7.10728 -1.53608 +288 2 15.7054 3.02501 14.6718 -21.9622 -5.02255 13.6584 +289 1 9.85637 15.4939 17.0026 6.25802 5.34328 -5.30261 +290 2 10.2013 14.6312 16.7411 3.93948 4.67059 -1.18803 +291 2 9.35728 15.3668 17.8085 -8.94372 -2.90673 5.88613 +292 1 11.2848 8.23994 16.5492 3.15289 33.2939 2.2253 +293 2 10.8315 7.75123 15.8747 -9.91387 -14.5897 -7.3255 +294 2 11.7506 7.62533 17.1016 4.32393 -13.5731 6.91104 +295 1 3.77097 18.1898 16.7118 5.96936 32.6304 11.943 +296 2 4.24576 17.6768 17.3569 8.77088 -19.0197 5.38959 +297 2 3.7978 0.441972 17.1008 -3.8528 -14.6362 -12.0582 +298 1 2.20581 4.09889 8.95874 4.57905 1.19328 9.26631 +299 2 3.00197 3.55544 8.74643 -17.2537 17.4622 14.7611 +300 2 2.10364 4.24367 9.94001 11.4926 -15.28 -28.3391 +301 1 9.9196 10.3581 9.75231 -27.966 16.15 -17.0738 +302 2 9.34403 11.1055 9.40387 24.0849 -21.7639 18.0289 +303 2 9.87032 10.282 10.7171 1.16507 9.52838 -7.01624 +304 1 9.73405 0.807167 10.8572 18.2139 21.6835 4.91261 +305 2 9.58177 18.5811 11.2204 -14.9491 -12.8069 -2.84973 +306 2 9.10878 1.03014 10.1675 -9.37034 -6.01821 -3.77915 +307 1 9.18221 15.2247 10.2123 -19.1642 -10.2407 -19.6365 +308 2 9.04674 16.0847 9.7631 0.663926 -17.4388 12.4081 +309 2 8.3908 14.6843 9.94105 22.9839 14.6501 17.4764 +310 1 1.00316 9.27987 10.329 14.3691 -27.2472 -11.0896 +311 2 1.16727 10.1904 10.5724 12.779 8.1681 -2.56256 +312 2 1.84996 8.76119 10.1498 -30.7163 35.51 10.5854 +313 1 16.8004 4.89338 8.19813 23.5039 -12.6505 29.7165 +314 2 16.1748 5.31624 8.83318 15.8467 -9.35353 -17.5774 +315 2 17.4877 4.38941 8.71628 -29.2517 16.802 -13.3541 +316 1 14.6379 14.6893 0.402347 -11.159 -0.978579 14.7724 +317 2 14.9609 15.3376 1.05877 0.0769081 -12.0935 -6.53519 +318 2 13.9048 14.1906 0.841144 15.9383 15.9909 -14.4014 +319 1 3.51181 11.0525 9.63829 2.1739 12.5105 -11.7746 +320 2 3.41507 11.3617 10.5484 4.86707 2.92948 -3.5212 +321 2 3.25155 11.8076 9.06383 -0.0479228 -15.275 7.06779 +322 1 11.0289 10.8695 1.26208 17.169 21.0662 -6.34954 +323 2 11.1535 11.716 0.753779 -4.03889 -27.9068 14.1765 +324 2 10.1142 10.5923 1.16471 -3.02205 2.54599 -1.38039 +325 1 13.2239 7.06188 12.8977 -30.3793 3.52384 -4.06516 +326 2 14.1381 6.84046 12.8922 25.6531 -5.59605 1.27225 +327 2 12.7471 6.22139 12.9668 3.13335 6.34025 -4.15647 +328 1 9.62584 1.88878 0.937813 20.0839 -1.09549 37.2578 +329 2 8.77484 2.11506 0.623903 -26.2152 1.3675 -15.013 +330 2 10.1764 1.70882 0.191067 9.10224 -0.512606 -16.4895 +331 1 10.6054 13.537 4.7508 -3.45661 -5.20977 -1.23778 +332 2 11.3208 12.9359 5.04367 -5.78837 16.6981 -6.98771 +333 2 10.4128 14.1619 5.47507 11.2154 -13.4565 -5.70688 +334 1 14.2525 1.6915 10.8868 25.1006 21.2848 4.13062 +335 2 15.0842 1.26497 10.6465 -4.75627 -8.22365 -3.1417 +336 2 14.5069 2.62992 10.8824 -13.5101 -4.08816 2.36647 +337 1 14.6678 12.4248 11.7157 -12.7858 -12.3306 -9.5252 +338 2 15.5574 12.5766 11.3177 -24.032 -11.5318 -4.29299 +339 2 14.0022 11.9667 11.1187 32.4402 16.632 10.9337 +340 1 8.24065 5.08218 9.78509 -7.81525 41.6802 29.5679 +341 2 7.45364 5.10173 10.3836 16.236 -11.1581 -20.3292 +342 2 8.36822 4.22882 9.41503 -10.4798 -31.0118 -7.50393 +343 1 1.59893 16.8132 18.3262 1.78713 43.6046 -19.4726 +344 2 1.99225 17.1675 17.4932 -13.4068 -2.95443 18.1753 +345 2 1.72693 15.8931 18.2458 9.12037 -33.6792 3.80865 +346 1 1.43382 17.2563 15.3383 70.3372 -10.1908 -13.5082 +347 2 1.32309 18.1562 15.5759 -5.39176 26.6374 11.2222 +348 2 0.623143 16.841 15.3782 -64.6751 -20.2725 0.847241 +349 1 3.73599 5.55499 6.2196 -13.8181 39.8005 -2.84681 +350 2 3.32092 6.26594 6.76194 2.21889 -20.7758 -8.723 +351 2 4.19567 6.05321 5.52665 5.67395 -4.434 2.61268 +352 1 12.357 9.41487 14.1826 15.3987 -29.3966 1.09302 +353 2 12.9591 8.63784 13.9021 -33.8501 34.209 16.2235 +354 2 11.936 9.15457 15.0346 16.6427 1.77305 -15.4117 +355 1 4.0362 15.2647 6.90572 33.8672 24.728 -7.08093 +356 2 3.45744 16.0249 6.7945 -6.17655 -1.99751 -5.28974 +357 2 4.92941 15.6518 6.66696 -29.006 -22.9584 9.78444 +358 1 0.606517 8.56128 14.8606 9.39684 15.8059 -8.30397 +359 2 0.498099 9.52604 14.9437 -1.87135 -9.61679 5.58044 +360 2 1.28855 8.50016 14.167 -9.83185 -6.21013 7.33103 +361 1 12.9763 8.3683 10.3434 1.19405 4.03237 -29.9304 +362 2 13.7163 7.90436 9.89822 -7.22584 1.47622 17.5396 +363 2 12.9003 8.0957 11.2534 8.23718 -11.529 10.7869 +364 1 15.2983 7.63672 3.47583 -36.323 -26.5913 31.5529 +365 2 14.5024 7.10501 3.29647 15.7237 15.5958 -25.1442 +366 2 15.2922 7.47095 4.43335 26.8259 14.207 -3.84044 +367 1 17.3208 6.63818 0.028906 -16.9884 17.5938 -6.80353 +368 2 16.7479 6.05403 0.554933 4.15554 3.30118 -7.73843 +369 2 16.7141 7.27151 18.2009 11.1968 -20.2911 18.275 +370 1 8.79355 6.92545 7.84172 -17.9944 -26.8715 17.7017 +371 2 9.63968 7.32585 7.85068 34.0918 14.4557 -5.0304 +372 2 8.77688 6.39871 8.67404 -5.99252 8.25367 -18.4431 +373 1 12.3209 0.607808 1.1741 -9.70621 -1.67076 -6.18378 +374 2 12.995 1.15082 1.58835 11.8921 -6.95349 3.94176 +375 2 12.79 18.5825 0.66073 -1.23695 5.23567 5.50046 +376 1 5.68514 15.097 14.5145 3.67475 30.0662 -16.0184 +377 2 4.72797 15.1695 14.4772 -3.92865 -1.97247 7.85561 +378 2 6.02476 15.8935 14.032 -4.97132 -21.5573 17.6103 +379 1 3.822 6.53853 1.67803 9.4136 -3.73603 -11.0507 +380 2 3.54968 7.33117 1.17576 -2.2757 -10.4776 17.1213 +381 2 3.81642 6.7886 2.60252 -0.785086 8.11893 4.5328 +382 1 3.89262 11.6088 12.227 13.3033 3.31132 5.82178 +383 2 4.72051 12.1032 12.348 -1.72331 -9.21471 -1.78635 +384 2 3.26281 12.0921 12.7526 -14.3078 7.33513 5.3451 +385 1 5.45444 3.88172 15.8755 10.9934 63.7886 22.8921 +386 2 5.90627 3.24049 15.3708 25.1493 -29.4334 -15.1609 +387 2 6.11665 4.65725 15.9739 -37.1513 -37.4972 -5.17498 +388 1 14.4636 10.317 4.39501 8.04256 -17.7362 -43.5508 +389 2 14.9051 9.88853 5.13417 -2.05112 -4.59794 0.583625 +390 2 14.7084 9.81768 3.53446 -13.0506 20.827 46.8358 +391 1 7.94949 17.2895 9.24469 -12.4073 10.6503 -4.49958 +392 2 7.23447 17.5423 9.86969 11.4984 0.663317 -18.2334 +393 2 8.01085 17.8889 8.47627 -8.74254 0.310971 13.2931 +394 1 4.4986 14.4237 3.96317 22.7921 6.59984 27.2073 +395 2 4.89523 15.3318 4.14709 -15.7294 -33.8816 -1.82578 +396 2 4.80237 13.7713 4.67129 -10.4496 32.1184 -24.135 +397 1 14.3358 7.38467 15.7635 24.4704 6.70756 7.84838 +398 2 15.2401 7.23754 15.391 -26.2451 3.74497 13.7384 +399 2 14.4998 7.83446 16.6232 -7.00308 -11.7114 -18.5693 +400 1 2.86875 18.2246 1.90934 8.22952 29.9251 46.5059 +401 2 2.54447 17.7626 1.17928 -17.7355 -34.6574 -39.0362 +402 2 2.08284 18.4154 2.45796 15.223 4.61378 -9.70941 +403 1 7.96139 1.61197 4.52525 29.4796 -3.5692 28.5612 +404 2 7.4985 1.83317 3.72811 -4.47294 12.8461 -13.1797 +405 2 8.84188 2.051 4.57628 -23.8244 -8.06079 -10.6756 +406 1 2.69247 14.1251 17.7583 -39.7925 -12.5472 14.0506 +407 2 1.78944 13.8074 18.0556 30.3506 3.26472 -13.0537 +408 2 3.33089 13.517 18.1683 -2.67461 8.7222 -7.81087 +409 1 0.711797 1.68055 13.8626 44.8563 0.102291 -15.8697 +410 2 0.854596 1.56791 14.7929 -2.34617 -4.64243 17.7358 +411 2 18.4557 1.86826 13.7064 -36.5874 5.33291 1.35002 +412 1 4.5582 18.5986 13.9691 17.69 -10.1212 -17.3986 +413 2 5.37614 18.0918 13.7297 -17.5363 18.7277 11.6893 +414 2 4.4096 18.4453 14.9034 -4.80692 -4.44744 5.40837 +415 1 7.10973 0.453475 18.3742 -17.6731 43.6393 33.9394 +416 2 6.99644 0.098599 17.5235 3.55611 -15.5456 -38.0778 +417 2 6.34312 1.05085 18.5323 11.5496 -19.3687 -0.295067 +418 1 16.0934 18.4421 14.1505 -13.5696 -24.3411 -34.6818 +419 2 15.444 17.7866 13.7542 20.5302 26.3107 23.9987 +420 2 16.0379 18.4915 15.109 -11.2087 -0.403296 -0.42938 +421 1 10.1156 4.52417 16.2956 -63.5341 -10.6596 -28.1335 +422 2 10.9808 4.34247 16.5381 54.6034 1.03427 17.4186 +423 2 9.84863 3.69679 15.8473 1.5569 12.8802 9.55133 +424 1 15.8226 17.9425 4.41327 -12.7412 7.89699 33.5898 +425 2 16.5547 18.5732 4.53052 -9.15632 -3.64108 -2.38506 +426 2 15.1071 18.2295 5.06915 28.1993 -15.1976 -35.9746 +427 1 6.9246 17.3574 13.7412 41.9162 15.5861 -1.52717 +428 2 7.49648 17.8115 14.4369 -23.1807 -22.4309 -23.3681 +429 2 7.52703 17.1963 12.9658 -13.588 5.84324 25.6525 +430 1 13.2892 6.57209 6.73437 -45.0771 -7.84691 9.23056 +431 2 14.2146 6.66317 6.83486 35.9508 1.69852 -11.4068 +432 2 13.0394 6.38579 5.82242 8.43649 1.47489 -3.25235 +433 1 7.6616 2.3861 9.17526 8.07841 -8.24756 -37.8228 +434 2 7.32169 2.39592 10.0555 -17.554 -3.79201 20.6206 +435 2 6.95914 2.1022 8.53308 18.9972 7.96045 22.8376 +436 1 15.1464 14.8771 13.6482 -9.08859 5.19149 1.30171 +437 2 15.0308 15.0223 14.6069 -2.64384 -0.244686 -12.5428 +438 2 14.3194 15.1152 13.1798 15.9342 -4.32482 12.4068 +439 1 9.29105 8.34315 3.70472 25.3147 -22.6228 7.1656 +440 2 10.1776 8.75859 3.73678 -14.6049 0.788849 -0.227964 +441 2 9.48378 7.39942 3.88081 -7.38963 16.6026 -2.51653 +442 1 17.6854 13.4687 16.4528 1.20699 34.422 -16.619 +443 2 16.7357 13.4337 16.3398 -3.15338 -8.61752 5.60033 +444 2 17.8844 14.3284 16.0065 4.30498 -21.0483 11.9174 +445 1 5.04883 10.6547 2.58751 21.171 -14.0773 3.70172 +446 2 5.87017 10.3468 3.04382 -23.0848 5.17759 -4.78185 +447 2 4.55197 11.1441 3.22928 -5.68041 9.33128 13.9497 +448 1 3.70566 8.3683 10.3381 2.8322 -31.099 -4.13864 +449 2 3.86061 9.29726 10.2176 3.71195 18.7597 0.626964 +450 2 3.86652 8.14601 11.2715 -4.70232 11.1023 -9.34814 +451 1 16.1079 7.11641 6.33859 19.1617 -15.4194 -14.8444 +452 2 16.7241 7.70559 6.80408 -7.69122 -6.37409 -7.38138 +453 2 16.6678 6.33083 6.12136 -24.1396 12.8226 8.63966 +454 1 15.2027 7.00502 9.1117 -12.4455 33.5656 -30.1004 +455 2 16.009 7.42176 9.46585 -11.7729 -5.93044 -7.51071 +456 2 14.9881 7.51375 8.25647 14.3105 -22.443 40.0586 +457 1 6.4525 13.1649 12.9201 -14.4212 4.62434 6.2224 +458 2 7.2977 12.7289 13.0561 -0.519457 -3.7562 7.19322 +459 2 6.25327 13.7237 13.7059 9.03992 -10.4089 -22.4145 +460 1 12.1145 4.49786 13.0694 60.1541 40.3897 -0.599702 +461 2 12.3852 4.68406 13.9868 -12.8154 -8.572 -1.53547 +462 2 11.3952 3.9317 13.0199 -51.9002 -33.7145 4.15206 +463 1 11.3323 8.18365 7.8522 33.2694 0.481688 12.7059 +464 2 12.0901 7.73501 7.43634 -16.2057 -1.97452 -6.97761 +465 2 11.7651 8.45102 8.68662 -20.5523 -0.0583287 -5.01537 +466 1 17.1666 10.776 7.42179 36.6255 -17.1838 -28.5238 +467 2 17.7906 10.0723 7.08441 -19.5131 16.2155 23.227 +468 2 17.2793 11.4524 6.73733 -13.1225 1.2547 8.82205 +469 1 5.22802 18.1471 11.05 -26.218 -15.3265 2.15414 +470 2 4.73762 18.1049 11.901 9.27461 0.443739 -18.2338 +471 2 4.62535 17.7417 10.374 18.9971 14.5949 15.121 +472 1 7.56653 17.6363 1.80821 2.05543 -3.48119 51.3305 +473 2 7.65741 16.7768 1.42856 8.63412 -18.3953 -16.9352 +474 2 7.35855 18.2549 1.13994 -1.30452 14.3677 -27.7338 +475 1 1.85092 12.9256 13.6076 17.4877 19.0754 23.2488 +476 2 1.72104 12.4156 14.4258 -6.17153 0.259213 -13.4945 +477 2 2.19932 13.7866 13.9501 -9.51965 -23.6336 -9.57422 +478 1 9.73868 6.79159 14.8001 -20.4051 42.5069 -0.796717 +479 2 9.95236 5.95211 15.1529 11.7083 -38.3225 9.01974 +480 2 9.967 6.84408 13.8723 6.06139 -4.97285 -7.43337 +481 1 15.2087 4.3972 10.7794 -26.9028 -24.0998 -25.0358 +482 2 16.0082 3.89203 10.8637 24.0661 5.32644 6.50358 +483 2 15.2102 5.16148 11.3322 8.70888 13.5856 17.3899 +484 1 11.1963 6.12482 0.150068 -24.122 -22.6006 13.7234 +485 2 11.2381 5.20796 0.481504 11.6671 13.7026 -10.2768 +486 2 10.2374 6.21547 18.6186 16.3103 12.5014 -3.12394 +487 1 0.19533 11.3359 15.1413 -21.6592 10.769 -30.7731 +488 2 18.4021 11.874 14.3993 14.4722 -20.1415 31.2795 +489 2 18.4481 11.661 15.9631 4.68348 9.49999 -5.94609 +490 1 7.06882 9.13032 7.26059 -22.6631 -3.09615 15.424 +491 2 6.55985 8.40099 7.69941 15.0645 18.9564 -17.5163 +492 2 7.9725 8.82922 7.21375 6.85038 -6.33336 0.902711 +493 1 18.4578 15.4507 12.3537 6.97015 0.808933 -7.22971 +494 2 0.776651 15.5698 12.2511 -16.5258 -3.56518 7.28193 +495 2 18.1456 15.6789 11.4721 -4.11121 -1.28038 2.68538 +496 1 16.5694 4.36967 5.25107 2.45626 -29.8761 41.2812 +497 2 16.7744 3.81151 6.06026 -19.4928 29.4804 -23.4548 +498 2 17.3898 4.32671 4.78168 14.6436 6.44337 -19.6343 +499 1 17.788 3.06911 10.7078 8.19486 16.3181 17.0759 +500 2 0.075758 3.1322 11.0257 -18.3141 -4.46618 -10.1687 +501 2 17.6332 2.20749 10.3226 7.04824 -10.7221 -5.22745 +502 1 12.3142 0.064083 10.1758 -16.6046 52.5698 5.40656 +503 2 11.3746 0.384648 10.259 27.2889 -19.3162 -0.832384 +504 2 12.8178 0.919304 10.3228 -10.5773 -40.3011 -9.47381 +505 1 10.3666 9.83315 12.2981 15.5663 4.35939 24.9446 +506 2 11.1015 9.85063 12.955 -12.9587 3.49885 -14.3711 +507 2 10.1328 8.91188 12.2898 -2.48305 -14.5784 -4.85859 +508 1 0.463654 2.82678 7.01839 21.5285 29.229 11.0876 +509 2 0.875324 3.58845 7.48211 -15.1018 -9.47019 -10.8481 +510 2 0.770257 2.12665 7.58365 -2.10845 -18.3887 2.87796 +511 1 0.478371 15.2358 6.91004 -5.05906 -57.415 8.40739 +512 2 0.585298 15.6463 7.75647 1.85019 10.3725 13.8373 +513 2 0.556531 14.2524 7.18353 -2.63305 52.383 -27.2731 +514 1 16.9534 7.00251 15.3394 -15.9191 6.08615 -6.45156 +515 2 17.6338 7.63543 15.0899 14.1822 -6.8729 3.83609 +516 2 17.3093 6.19568 15.7235 10.8839 2.85836 -7.52482 +517 1 9.0001 12.4151 8.13768 -31.1102 30.9609 25.8163 +518 2 9.37386 11.8218 7.49742 -5.17233 -14.4246 -22.3971 +519 2 8.02402 12.632 8.03373 38.2843 -19.0142 -6.47162 +520 1 1.27238 1.95406 3.05803 -13.5483 -7.94682 -18.4152 +521 2 1.26084 2.61511 2.34121 0.274888 -9.5029 12.9388 +522 2 1.89031 2.22344 3.73293 6.76618 11.1556 -0.474465 +523 1 4.13907 15.1156 9.62039 -21.6353 8.89781 12.928 +524 2 4.07003 15.1439 8.65747 6.73796 -2.17255 1.87071 +525 2 4.96029 14.7006 9.86457 13.8731 -5.89958 -3.36363 +526 1 7.17628 2.17866 14.5671 10.1969 15.6665 0.500505 +527 2 6.99528 1.68402 13.7698 -5.58163 -4.27811 -6.1139 +528 2 7.62131 2.98432 14.249 -3.31044 -9.5634 8.35677 +529 1 18.6082 14.7131 2.1481 32.6395 -16.0207 -3.46113 +530 2 0.838003 15.1297 2.25966 -5.15041 -8.02703 -3.38947 +531 2 17.988 15.3544 2.42675 -27.9684 22.1971 4.74449 +532 1 9.94138 2.79524 12.9422 16.7157 -19.9527 -5.96647 +533 2 9.79404 2.1456 12.2228 -2.63367 12.9584 8.66897 +534 2 9.17835 3.36299 13.0326 -7.96092 5.51528 -6.54514 +535 1 2.80444 8.90955 13.0076 -17.7822 -13.1167 0.317539 +536 2 3.06361 9.80599 12.872 10.5962 22.9278 -4.25378 +537 2 3.5122 8.48618 13.4775 15.1932 -9.60442 7.00981 +538 1 3.236 8.3574 3.63664 -2.86765 -22.2709 68.2353 +539 2 3.45085 9.0718 3.07326 14.564 28.9211 -13.7717 +540 2 3.47645 8.58669 4.60794 -11.4307 -4.68562 -51.1711 +541 1 5.62853 7.18594 8.51094 8.63755 21.4894 2.16978 +542 2 5.46784 6.31815 8.13889 -3.95344 -9.53044 10.3317 +543 2 4.96415 7.47792 9.15047 -3.24726 -12.0183 -2.29801 +544 1 14.8757 1.26039 2.01768 8.95967 6.82752 -28.1452 +545 2 14.9353 2.01952 2.56559 -6.40438 15.8227 28.9683 +546 2 15.2784 1.60993 1.21235 -4.35761 -14.1118 -5.79377 +547 1 8.22892 15.2012 0.850139 10.8537 -12.6178 7.38979 +548 2 9.02213 14.9338 1.33488 2.38301 14.3333 -0.830013 +549 2 7.55366 14.6663 1.27665 -9.08858 2.03607 -6.2405 +550 1 15.6387 1.34587 7.23673 -38.2068 -12.1482 -8.38322 +551 2 14.9277 0.724731 6.91269 26.6184 17.4884 8.18161 +552 2 15.1173 2.1119 7.53894 10.4663 -3.86302 -4.52487 +553 1 4.90142 13.0959 18.5232 17.6249 -4.01801 23.9701 +554 2 5.32755 13.082 0.76977 -10.7656 0.632793 -19.6876 +555 2 5.44764 13.7122 18.0259 0.499955 -3.74815 -4.96885 +556 1 15.3368 8.46948 18.1479 21.2409 26.352 -19.7425 +557 2 15.8061 9.12264 17.5623 -15.5364 -21.5252 11.6976 +558 2 15.3318 8.91689 0.353875 -5.84476 0.442576 5.05054 +559 1 12.0708 3.01842 18.3809 -8.91332 38.2285 -17.9492 +560 2 11.9316 2.65996 0.60646 7.08072 -18.979 4.32412 +561 2 12.6022 2.47389 17.7995 4.78982 -18.1658 8.07002 +562 1 13.2139 12.6752 5.17768 -9.57044 10.0795 -9.57129 +563 2 13.7464 12.0348 4.69253 1.60656 -5.44915 8.62561 +564 2 13.2564 12.5123 6.11793 10.4898 -3.48459 7.66387 +565 1 6.05443 7.0356 0.031519 0.0605761 -19.9038 6.17744 +566 2 5.93935 7.95118 18.5019 3.71712 34.2187 -1.98634 +567 2 5.39095 6.86665 0.702638 -7.83388 -10.1683 0.476271 +568 1 17.7528 16.0276 15.0213 -25.9758 6.2762 6.79882 +569 2 16.9476 16.5457 15.105 3.54626 -1.67183 20.5845 +570 2 17.7479 16.0055 14.0813 22.8568 -13.146 -30.1028 +571 1 13.196 0.994907 16.5363 6.37162 1.07879 13.9702 +572 2 14.1481 0.997912 16.7614 -14.4757 -4.73392 -6.84542 +573 2 12.8833 0.094199 16.7238 3.07394 5.84273 -8.05351 +574 1 11.1253 14.5647 7.20271 13.6513 20.7581 -19.5035 +575 2 10.4007 14.3183 7.72981 -32.979 -9.13798 24.3252 +576 2 11.7186 13.8255 7.26943 15.8912 -3.80541 2.99114 +577 1 17.5081 8.62849 2.08107 17.5857 37.593 18.6886 +578 2 16.6801 8.63471 2.55495 -11.5266 -11.0229 1.73392 +579 2 17.5233 7.88242 1.516 -4.85302 -28.502 -20.2632 +580 1 12.3547 8.01168 2.02213 2.8693 7.47745 -2.1033 +581 2 12.2384 8.8582 1.54611 -1.5199 -14.1485 9.25757 +582 2 11.9739 7.3152 1.48261 -4.60849 0.564674 -12.802 +583 1 11.8761 14.6165 10.3364 -1.28632 -27.1744 -11.0444 +584 2 12.1004 13.7873 9.81464 -15.5434 34.4502 21.6186 +585 2 10.8993 14.6888 10.473 22.8986 -6.0814 -12.7032 +586 1 6.89524 7.05211 15.6117 2.70483 5.93472 10.8866 +587 2 7.81004 7.26536 15.3122 -19.1207 -0.823892 9.8847 +588 2 6.66676 7.54167 16.4408 15.3743 -10.0989 -25.4065 +589 1 8.00326 4.73593 13.4743 46.2088 18.1039 21.0673 +590 2 7.23337 4.7302 12.9572 -37.1051 2.19442 -26.1447 +591 2 8.40671 5.62958 13.343 -9.63909 -26.9075 5.20654 +592 1 13.4128 12.1818 14.2522 -5.46405 -2.8504 7.05596 +593 2 12.9414 11.3292 14.2657 10.1901 3.29349 -5.65079 +594 2 13.7875 12.315 13.3696 -1.58979 -2.51674 3.72795 +595 1 14.8395 9.42189 7.30548 -10.1492 -33.0314 -14.9507 +596 2 15.7087 9.765 7.42505 18.3001 17.1245 4.25051 +597 2 14.2269 10.0768 7.57319 -16.3703 19.68 11.0075 +598 1 12.6526 17.0686 3.07252 -25.5483 38.6692 13.4046 +599 2 12.8376 17.5237 3.93373 3.7914 -19.7635 -24.6942 +600 2 11.9913 17.6958 2.63477 29.3498 -30.5169 14.5322 +601 1 1.15545 7.13838 17.4647 -1.30818 10.8795 -24.4228 +602 2 0.330359 7.36323 17.9184 3.51096 -10.352 -1.0007 +603 2 1.05514 7.47868 16.5422 2.6229 -4.15873 21.1004 +604 1 12.7562 5.15096 15.6457 46.9745 -3.15458 16.4241 +605 2 13.4512 4.55662 16.0315 -23.8856 11.8204 -16.5269 +606 2 13.2414 6.00335 15.5788 -13.869 -10.6853 0.37407 +607 1 2.53993 3.38757 4.97618 -24.4059 44.0626 48.9955 +608 2 1.7609 3.18232 5.58922 29.5313 1.39757 -24.0522 +609 2 2.84154 4.31546 5.27885 -6.94106 -48.8689 -12.2378 +610 1 8.33186 11.2983 13.4548 -25.447 4.99647 44.923 +611 2 8.4244 11.0562 14.4444 7.04045 1.38295 -54.395 +612 2 8.91168 10.8786 12.8197 20.7237 -12.5345 14.2107 +613 1 12.8689 1.31514 13.3384 4.70567 59.9078 -15.5432 +614 2 13.42 1.58034 12.5659 -9.46235 -19.1343 13.2352 +615 2 12.4231 2.17844 13.5496 8.70338 -32.6779 -3.58081 +616 1 6.34008 13.7169 2.14963 -19.3306 -6.11379 22.757 +617 2 5.63978 13.877 2.82959 17.9638 4.85668 -21.8758 +618 2 6.88351 13.0442 2.56282 8.57629 -2.48731 -1.94932 +619 1 15.9206 6.61444 12.7992 -23.3103 -26.3741 2.68057 +620 2 16.3106 7.25195 12.2393 16.9755 20.6681 -18.7226 +621 2 16.4213 6.59661 13.608 7.79648 1.05266 12.4236 +622 1 16.8298 0.712824 9.59482 4.79811 -22.8344 -3.47194 +623 2 16.8791 18.3713 9.72616 -6.98639 26.8255 -1.99774 +624 2 16.5452 0.8605 8.67269 -2.39382 -2.67689 10.2173 +625 1 6.14624 11.7631 8.37671 0.189841 -56.9827 6.97012 +626 2 5.32447 11.4591 8.84151 16.7156 13.8425 -13.046 +627 2 6.64226 10.8931 8.20176 -19.0535 39.3101 2.14415 +628 1 2.88754 8.61261 0.453821 12.2401 -11.553 -23.675 +629 2 2.45212 8.04764 18.3917 -4.84247 31.247 26.7064 +630 2 2.34875 9.28564 0.895642 -13.4946 -8.81401 -13.4914 +631 1 10.1674 10.4623 6.50123 4.87464 -2.88608 -13.8248 +632 2 10.6087 9.69731 6.89122 -0.620763 2.00125 4.93232 +633 2 10.4694 10.4636 5.56932 -5.34739 2.02001 15.3519 +634 1 6.7142 15.6951 6.55167 22.995 7.84961 12.6004 +635 2 7.14328 16.1838 7.27089 -9.73558 -8.55589 0.364412 +636 2 7.21237 16.006 5.79102 -10.9792 5.43097 -10.3878 +637 1 6.445 13.1807 5.57797 -3.32019 -20.8794 2.06608 +638 2 6.7301 13.9465 6.07331 -1.80129 7.88671 5.96843 +639 2 6.09943 12.5433 6.22286 1.13913 6.90777 -2.85329 +640 1 16.8242 12.5629 9.83758 3.36613 -21.9924 0.476486 +641 2 16.9985 11.8651 9.16533 -5.29916 18.5903 6.02329 +642 2 16.5644 13.3844 9.42716 1.61266 3.35571 -10.8679 +643 1 6.03738 2.95058 2.86354 -7.51536 -24.4327 -2.00067 +644 2 6.40977 3.757 2.57075 14.9417 32.1903 -3.64532 +645 2 5.57703 2.61747 2.09059 -4.23441 -8.07329 -3.19257 +646 1 10.9114 3.33767 3.30112 3.4906 -2.16377 5.30702 +647 2 10.297 4.02722 3.58926 -1.61521 -6.66566 -5.52383 +648 2 10.5127 2.84524 2.57795 -5.77666 1.81375 -3.43243 +ITEM: TIMESTEP +10 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.68194 7.08301 17.95 -9.31723 -4.61569 5.17534 +2 2 7.78696 6.81626 18.2438 14.604 4.05464 -8.83536 +3 2 8.80373 6.759 17.0506 -2.23465 -3.10488 4.80291 +4 1 18.5422 8.2512 6.84005 -1.85374 20.2636 49.1182 +5 2 0.133718 7.9438 5.98823 13.4692 -17.0673 -32.1853 +6 2 0.402402 7.78616 7.5434 -4.29735 0.835788 -17.7519 +7 1 8.38516 18.5522 6.81414 18.1861 9.65042 -3.37417 +8 2 9.3349 0.126592 6.72298 -16.1755 -3.42506 1.43069 +9 2 7.92248 0.594936 6.31239 0.819355 -0.881225 3.09059 +10 1 6.59178 1.84314 11.71 32.0023 -4.98621 -11.2566 +11 2 5.89352 2.36713 12.0513 -24.1224 14.8358 13.0259 +12 2 6.19214 1.0378 11.3953 -8.69892 -12.638 -2.90229 +13 1 7.13386 5.75674 2.33026 -14.5408 0.616599 17.9391 +14 2 6.48306 6.1089 3.01881 22.5383 -2.3727 -34.6055 +15 2 7.09544 6.2305 1.47237 -10.8297 -1.47351 21.389 +16 1 16.2171 10.1491 16.1328 -28.1801 3.24526 14.6911 +17 2 17.0032 10.2274 15.6211 19.8027 8.68317 -10.1896 +18 2 15.8342 11.0337 16.2804 9.6716 -6.93987 -4.62354 +19 1 10.6069 15.0266 2.30703 -4.98248 -17.7421 -7.27467 +20 2 10.5595 14.4209 3.0573 0.524935 2.03122 3.93242 +21 2 11.0455 15.8043 2.63229 7.74565 12.2645 5.86516 +22 1 17.1614 8.24714 10.3877 8.07926 1.42828 6.48104 +23 2 16.5623 8.78009 10.9215 0.0316367 4.64377 2.31684 +24 2 17.9785 8.76022 10.2824 -6.97801 -4.40732 0.702868 +25 1 14.8935 15.8724 16.3278 20.2214 -7.01151 6.5945 +26 2 14.0152 16.2142 16.2283 -22.9266 5.478 3.03945 +27 2 14.9126 15.3591 17.1528 -4.85523 2.97165 -4.07838 +28 1 12.1655 13.3835 0.413391 7.36911 -14.3954 12.824 +29 2 12.1103 13.7323 18.1651 -6.85057 6.78658 -3.29346 +30 2 11.6807 13.9152 1.05851 -4.03153 8.23708 -7.75902 +31 1 9.27599 5.36662 4.05276 -29.4571 7.127 11.0843 +32 2 8.67176 5.26931 4.85064 22.4619 1.60875 -30.6294 +33 2 8.67539 5.53054 3.28716 9.26602 -4.36827 15.8404 +34 1 1.82909 4.27439 11.6483 -10.3032 26.7578 -2.81239 +35 2 1.73625 5.21877 11.9337 1.99226 -22.9368 -8.90994 +36 2 2.3645 3.83767 12.2983 6.89168 -8.93952 11.7704 +37 1 1.96701 6.83625 8.36791 0.700563 -10.6105 -3.76521 +38 2 2.46094 7.16371 9.10974 5.61647 13.7513 9.96296 +39 2 1.91553 5.8986 8.57777 -2.9792 -4.95164 -6.48224 +40 1 5.40472 4.39468 7.93775 -13.5219 -10.4794 -16.6571 +41 2 5.47247 3.43369 7.82443 4.19114 6.69916 9.09153 +42 2 4.75726 4.62849 7.24994 8.09624 5.59982 9.8174 +43 1 3.2394 2.92305 17.5474 -0.484589 33.1528 15.1222 +44 2 3.93082 3.31406 16.9898 -0.722116 -4.79924 0.441987 +45 2 2.93778 3.68549 18.1255 3.8058 -28.2307 -17.5498 +46 1 7.46921 5.27133 6.11017 -1.04832 -15.5011 48.3459 +47 2 7.90561 5.59719 6.92877 -0.90713 11.0324 -30.0179 +48 2 6.96076 4.54233 6.5205 0.0145083 12.7024 -20.8234 +49 1 9.7753 7.02229 11.9825 10.38 0.905424 28.7819 +50 2 10.3185 6.36588 11.5577 3.53671 -5.58238 -7.94156 +51 2 9.14507 7.32646 11.347 -14.6838 3.32198 -19.6076 +52 1 14.1071 3.54759 8.03608 -23.8038 4.02857 -21.7378 +53 2 13.5341 4.25359 7.68722 9.9361 -9.73972 0.838395 +54 2 14.4214 3.88758 8.85457 11.6 9.53944 21.926 +55 1 4.79933 17.2591 4.02624 -13.379 0.496236 -8.73431 +56 2 5.57386 17.851 4.10922 -16.5825 -9.69995 -7.24814 +57 2 4.20396 17.5018 3.27728 17.9024 3.63898 12.5287 +58 1 16.5033 16.6227 10.0525 8.55043 -2.52252 -17.4646 +59 2 16.0579 16.4137 10.8501 -12.2091 1.77219 28.6058 +60 2 15.9447 16.1927 9.39741 3.82195 1.69594 -5.2917 +61 1 1.95551 4.92482 0.485806 10.2127 4.96395 -0.662752 +62 2 2.54163 5.27617 1.19707 -10.7364 -3.48306 -18.9921 +63 2 1.87778 5.63364 18.4632 -0.0680824 -4.88148 10.5435 +64 1 11.8064 13.3616 16.2803 -11.2011 -32.854 -16.2783 +65 2 11.3068 12.5375 16.4476 0.201944 14.5536 10.5803 +66 2 12.2047 13.1237 15.424 4.38621 16.2025 8.43328 +67 1 10.1065 11.0626 16.9483 14.8798 -23.3813 0.89342 +68 2 10.5718 10.2022 17.1278 -15.1514 23.106 -6.44625 +69 2 9.22125 10.8281 16.6474 0.614925 -0.65596 2.44857 +70 1 11.7253 17.5378 13.4688 -9.94093 -22.0621 2.41868 +71 2 12.2582 16.9669 12.8891 0.443382 11.1567 2.15207 +72 2 12.0419 18.4322 13.3705 7.56806 8.72697 -4.32807 +73 1 6.34321 9.31538 12.2256 -11.115 -24.1278 -16.4431 +74 2 6.95505 8.9709 11.5438 -2.74015 10.4344 10.5225 +75 2 6.7633 9.99127 12.7388 17.4243 13.1424 4.46627 +76 1 16.2194 12.7233 2.70094 -4.61478 -5.953 2.95318 +77 2 17.0002 13.1906 2.44934 22.4693 3.83429 -6.00104 +78 2 15.5655 13.415 2.69545 -17.2672 7.42791 2.42646 +79 1 0.634553 12.563 5.85853 -28.5577 11.9856 -12.6208 +80 2 0.914444 12.5082 4.92832 1.43228 -1.32003 11.8657 +81 2 18.3286 12.8558 5.76638 29.2028 -10.3468 5.65715 +82 1 5.19236 16.3841 18.4962 26.3246 -0.931967 -7.14386 +83 2 5.89246 15.8922 18.0344 -14.3156 -2.38899 -1.49205 +84 2 5.72254 16.912 0.454606 -10.9177 5.22319 5.94171 +85 1 0.515157 7.6307 4.06432 40.0561 19.3507 -22.9165 +86 2 18.554 8.04388 3.41083 11.6748 -7.97607 10.9949 +87 2 1.4672 7.83805 3.73432 -48.6916 -7.92141 18.8197 +88 1 3.14333 8.89821 6.52388 -38.7347 7.47588 -5.16066 +89 2 3.55606 8.61579 7.33755 0.264066 -1.79724 4.80444 +90 2 2.15121 8.92424 6.67318 38.4004 -3.38228 -2.38687 +91 1 7.3156 10.3041 16.1747 -22.5262 4.44621 22.8692 +92 2 6.53394 10.4783 15.6406 9.03524 -0.350523 -4.2891 +93 2 6.93671 10.3234 17.0875 14.5541 -1.9474 -13.7178 +94 1 11.1094 1.06061 5.00017 -8.33223 -1.63593 -20.1003 +95 2 11.1653 1.90766 4.53999 7.02718 4.91961 9.72987 +96 2 10.7116 0.517103 4.29895 3.46448 -7.62041 12.1963 +97 1 4.44086 2.70257 13.2121 -8.76198 -6.25056 -12.8305 +98 2 4.61839 3.20254 14.0253 0.411253 -15.6801 0.294236 +99 2 4.37598 1.71769 13.3483 2.92355 28.3656 12.0639 +100 1 8.41481 10.0299 1.78755 2.58083 -12.9704 20.4417 +101 2 8.40154 10.6596 2.53141 -0.930044 -1.16348 -6.83089 +102 2 8.61337 9.15635 2.20556 -3.35942 21.7495 -11.7521 +103 1 10.5245 1.75336 15.553 -8.62776 -1.95945 -5.61675 +104 2 11.4377 1.70086 15.8172 12.2485 -3.82632 7.39579 +105 2 10.5516 1.84495 14.595 -9.16331 1.82149 -1.12185 +106 1 2.77042 12.9421 7.75317 -7.76237 -6.33315 7.0975 +107 2 3.33238 13.5624 7.27685 -2.67968 -0.352894 -3.41328 +108 2 2.03777 12.7029 7.16368 7.79305 2.46945 -1.53229 +109 1 3.64399 11.6862 5.32015 -16.8384 -12.8234 -6.75612 +110 2 3.34983 11.0669 6.0167 8.99611 10.2661 -11.4747 +111 2 2.85416 11.8487 4.76712 13.6242 -0.0526402 5.20338 +112 1 6.87773 14.4784 16.8504 -8.96924 2.55968 -2.39612 +113 2 7.58262 13.8601 16.6681 3.90388 -1.06505 3.99858 +114 2 6.56163 14.7581 15.9821 -2.66358 -1.99085 3.97159 +115 1 14.1744 14.5416 3.41044 10.3942 -0.651763 -8.74467 +116 2 13.655 15.3132 3.20132 -4.79611 11.1016 -3.67227 +117 2 13.7666 14.1672 4.18264 -6.53868 -10.5118 9.50782 +118 1 8.26761 18.1769 16.0723 60.4333 -9.62543 6.95109 +119 2 8.90915 17.473 16.3173 -32.2452 -3.35667 -3.16806 +120 2 8.92378 0.250762 16.016 -23.6515 10.2222 -7.97846 +121 1 4.73314 1.61844 4.90498 10.4838 29.1168 -20.5116 +122 2 3.92346 2.13642 5.08344 11.5633 -7.75976 -5.77828 +123 2 5.26159 2.15735 4.23518 -22.3286 -21.1319 29.8735 +124 1 15.1246 12.8394 16.4387 17.4381 -4.51065 31.9511 +125 2 14.6778 12.9897 17.2989 -1.10989 -1.43715 -21.8055 +126 2 14.5277 12.6911 15.7205 -25.4533 -1.78625 -11.0751 +127 1 15.7863 18.3852 16.7922 25.908 13.3822 31.678 +128 2 16.4574 18.6243 17.5189 -32.4234 -15.7026 -31.1655 +129 2 15.6278 17.4293 16.8067 2.01305 5.51074 5.25351 +130 1 1.13886 1.13555 16.5514 1.07915 19.6556 20.6288 +131 2 1.93696 1.57732 16.8903 -4.88731 -5.90564 -11.4186 +132 2 0.480719 1.50241 17.171 6.36092 -10.7053 -11.3623 +133 1 18.0845 4.58532 15.87 11.914 -13.2929 -3.66508 +134 2 18.5793 3.94883 15.3177 -8.66069 11.808 8.70591 +135 2 18.5822 4.70936 16.6848 -0.518448 -1.56194 -3.55701 +136 1 12.2302 16.9486 16.128 -37.9176 -11.5423 26.3029 +137 2 11.3914 16.5899 16.5469 36.4287 7.40626 -6.62059 +138 2 11.916 17.193 15.2634 5.93841 3.5336 -18.1806 +139 1 15.8788 2.54988 17.9721 5.087 5.67773 0.124923 +140 2 15.7549 3.4391 18.3687 -1.45045 -15.8437 -11.8457 +141 2 15.6801 2.58174 17.0093 2.38633 7.36977 18.7833 +142 1 6.70786 13.8001 10.254 -2.60372 -2.62943 9.53833 +143 2 6.60649 13.5148 11.1732 2.18143 10.2669 -0.00882184 +144 2 6.57676 12.9909 9.76432 1.5038 -4.69959 -12.8892 +145 1 10.141 18.2121 2.80409 9.87418 27.4677 -18.8777 +146 2 10.2555 0.291999 2.14056 -0.137226 -16.5556 14.9505 +147 2 9.2689 17.8819 2.61553 -12.127 -4.1331 -0.131977 +148 1 2.97228 17.7542 6.06181 -6.28377 0.301135 37.0401 +149 2 2.07671 17.601 5.72694 10.6784 2.25774 -14.0772 +150 2 3.63482 17.801 5.37776 -0.270923 -2.52512 -18.6151 +151 1 12.5659 17.001 7.96656 -23.415 -18.3905 24.197 +152 2 11.9071 16.2804 7.97312 11.7411 4.46809 -11.7089 +153 2 12.3405 17.4671 8.78984 12.2149 7.72109 -10.0441 +154 1 14.887 15.2779 8.2893 -14.8827 1.47652 2.73183 +155 2 14.0296 15.7117 8.25541 -5.1427 0.792443 13.0916 +156 2 15.1979 15.4906 7.42354 24.2513 -3.00083 -20.068 +157 1 17.5454 18.3111 0.374663 -13.7707 -4.14946 -2.00055 +158 2 18.2555 17.754 0.11924 20.0055 -25.3354 -15.9225 +159 2 18.0059 0.295965 0.896687 2.592 26.2966 16.2474 +160 1 0.909555 10.373 1.4127 -25.0541 -38.6286 23.1399 +161 2 0.0989843 9.87796 1.71715 28.402 10.794 -7.01331 +162 2 0.540787 11.0804 0.922273 -7.26144 30.0328 -22.846 +163 1 1.56438 12.1819 3.32547 9.10171 15.3717 9.49092 +164 2 1.376 11.5384 2.66679 -5.32309 -27.3061 -8.25977 +165 2 1.61002 12.9703 2.79202 3.36268 15.5511 3.76031 +166 1 0.549815 17.2556 4.8751 10.3167 15.4421 -19.2536 +167 2 -0.00199658 17.9163 5.26632 -10.5855 22.2192 -2.30371 +168 2 0.434878 16.519 5.43169 0.723696 -37.6018 20.4622 +169 1 1.10394 1.00198 9.3932 22.7427 9.86492 -7.57605 +170 2 1.42144 0.685439 10.2466 -8.09769 -6.36772 6.76546 +171 2 0.213433 0.697197 9.27667 -15.9263 -9.88137 4.21803 +172 1 16.7947 2.33275 13.2864 3.73194 4.84267 -27.3174 +173 2 17.0439 2.54012 12.3481 -6.98409 -4.39606 26.1758 +174 2 16.4729 1.42155 13.294 0.162444 -0.657512 2.21945 +175 1 2.4659 15.8297 12.1956 27.3811 -11.2673 13.1923 +176 2 2.9226 15.5311 13.0144 -9.82996 7.11615 -19.573 +177 2 2.93231 15.4201 11.4444 -5.86947 6.23921 4.54204 +178 1 16.4361 15.5441 5.94616 -3.08145 19.3328 -8.8947 +179 2 17.3593 15.4783 6.2724 -11.5576 7.7283 -8.52746 +180 2 16.3183 16.2893 5.29043 11.1937 -18.2696 22.1006 +181 1 5.84475 5.01999 11.7951 -3.08481 -3.45829 -4.75382 +182 2 5.52388 5.87345 12.0737 0.2772 11.9484 7.56792 +183 2 5.11411 4.43946 12.0133 1.47645 -8.9756 -0.689037 +184 1 15.224 4.86392 0.726277 -25.4938 -12.7349 25.4219 +185 2 14.7355 4.51715 1.53205 23.492 12.9767 -22.6649 +186 2 14.5328 5.02763 18.7193 1.17802 2.78752 1.94947 +187 1 16.3449 16.2967 2.11437 10.483 7.37611 -22.6614 +188 2 15.9997 16.7982 2.83675 -10.4405 6.50893 22.1211 +189 2 16.6677 16.9984 1.52582 -1.93062 -9.0043 0.169523 +190 1 0.302094 4.87802 3.79689 -13.2533 37.9479 3.00012 +191 2 0.313912 5.8808 3.95538 6.86913 -44.9842 -7.10747 +192 2 1.1462 4.49233 4.0346 3.71094 3.5442 4.02727 +193 1 2.9221 14.9895 15.0397 8.46471 -6.33736 14.5665 +194 2 3.00495 14.6058 15.9566 -9.31495 16.4585 -22.1508 +195 2 2.45729 15.8402 15.0938 1.85721 -3.29548 9.95349 +196 1 1.12 14.5717 9.56227 17.989 48.8934 -19.0037 +197 2 2.07414 14.5222 9.32346 -20.956 -13.4859 7.84449 +198 2 0.791626 13.7731 9.9282 4.87275 -29.8773 11.3577 +199 1 13.6624 16.6636 11.5457 -10.5327 9.77879 -22.0557 +200 2 13.3286 17.4311 11.0186 6.18992 -14.9435 17.5347 +201 2 13.3805 15.8992 11.021 -2.34987 0.215756 7.80532 +202 1 4.73359 1.47857 0.718618 -25.3973 -6.06392 2.87887 +203 2 4.17185 2.00661 0.129453 7.95287 0.81937 2.61464 +204 2 4.09095 0.858388 1.12753 14.212 5.94905 -1.43657 +205 1 1.42476 18.4735 11.9056 -5.99404 19.5083 -8.93412 +206 2 1.23513 0.382953 12.6723 -0.378912 0.915416 0.341246 +207 2 1.89505 17.7259 12.2433 7.21066 -16.1249 4.04173 +208 1 11.5448 10.106 4.11346 25.2596 15.8213 -25.5125 +209 2 11.5283 10.5663 3.22641 -2.70186 -14.3529 26.6987 +210 2 12.5027 10.081 4.37886 -27.2068 -0.404219 -8.52489 +211 1 8.37485 12.1748 3.75184 -11.9448 24.9759 46.3975 +212 2 9.17743 12.5878 4.11803 1.10724 -8.54244 -18.9118 +213 2 7.75197 12.4339 4.49102 7.61965 -18.0915 -33.0697 +214 1 14.3244 4.03247 3.293 11.3964 4.48411 20.4985 +215 2 14.943 4.18459 4.05162 -10.8147 -3.75721 -20.4981 +216 2 13.4909 4.45368 3.55282 4.29688 -1.92648 -2.70238 +217 1 5.58313 1.77339 7.50694 -37.3093 -46.6507 29.7736 +218 2 4.97145 1.12464 8.0478 36.2685 39.0776 -31.448 +219 2 5.37556 1.59155 6.57949 1.79923 3.69516 -0.386563 +220 1 17.9058 1.11523 4.88403 9.14173 18.8744 -7.73144 +221 2 18.4454 1.57607 4.20954 -6.0377 -15.1011 6.62684 +222 2 17.7347 1.81107 5.53023 -2.74058 -7.94095 2.09707 +223 1 6.8279 9.39776 4.48823 3.62694 -0.974221 -6.28613 +224 2 6.84568 9.51125 5.43283 -7.5389 4.30482 14.2207 +225 2 7.717 9.07508 4.31798 2.90721 -0.358573 -8.96695 +226 1 2.70207 14.9601 1.96467 9.48597 -9.94138 -22.1344 +227 2 3.35633 14.7518 2.62888 0.238693 -0.206349 10.2383 +228 2 3.16249 14.7444 1.12616 -13.7934 7.99556 12.9651 +229 1 17.2754 12.8959 13.1352 7.09139 -37.5845 3.69594 +230 2 16.3537 13.1102 13.3148 3.80173 19.6017 -1.81888 +231 2 17.838 13.6507 12.9698 -8.26303 20.1956 -1.14982 +232 1 15.0171 10.5799 1.38486 -27.8548 -28.8799 -20.6854 +233 2 15.5438 11.2121 1.82149 21.7425 28.5078 17.6295 +234 2 14.2994 11.069 0.967203 2.72678 -1.55793 4.42244 +235 1 5.71388 6.94387 4.52744 5.06868 -23.5408 12.0019 +236 2 5.87421 7.87915 4.41499 3.45829 8.88765 -0.888191 +237 2 6.40286 6.63416 5.14703 -8.303 0.627238 -7.76707 +238 1 8.10838 8.26645 10.1831 -2.58942 7.80898 11.2224 +239 2 8.62669 8.8788 9.66253 10.4484 9.83111 7.1505 +240 2 7.63286 7.80673 9.50478 -12.057 -13.4779 -6.03182 +241 1 13.5281 18.2914 5.80176 -22.4215 -1.8227 14.6872 +242 2 12.749 0.212336 5.63336 9.50875 -1.85743 -1.68773 +243 2 13.2346 17.7232 6.55015 8.07385 12.1374 -16.5266 +244 1 0.320637 2.55746 0.113707 -24.4854 52.0087 1.52013 +245 2 18.0083 2.70852 18.6241 7.28296 -16.9077 1.12853 +246 2 0.626424 3.4996 0.197011 8.79214 -31.4205 1.87945 +247 1 12.6453 10.9632 9.76861 -25.4211 42.834 -14.9231 +248 2 11.6492 10.8795 9.70071 37.3368 -7.50244 3.90461 +249 2 13.0228 10.1402 10.0352 -3.08107 -28.1376 6.91694 +250 1 0.78452 12.2807 11.0864 19.7349 -6.9692 -1.93691 +251 2 18.4749 12.3028 11.1225 -11.4863 3.49833 6.83674 +252 2 1.15231 12.659 11.9029 -10.6903 -3.95248 -3.68276 +253 1 5.04293 7.22507 13.482 3.09598 5.99749 -4.73795 +254 2 5.58886 7.93262 13.132 -0.232718 7.71962 -10.0141 +255 2 5.52798 7.00144 14.2755 -0.932575 -7.50807 9.86229 +256 1 1.28071 6.97469 11.8373 -31.3117 -37.3004 -11.5925 +257 2 0.492113 7.17802 11.3051 9.94401 -3.39318 6.90536 +258 2 1.685 7.80152 11.9673 18.2328 34.095 8.03536 +259 1 15.4541 9.47192 12.3133 5.85738 22.5951 5.06509 +260 2 15.5175 10.4638 12.3742 -4.62374 -31.0112 4.63394 +261 2 15.4968 9.06746 13.1992 -1.35817 12.6181 -10.5463 +262 1 16.6442 12.9519 5.45538 -21.4717 15.277 -31.3145 +263 2 16.3435 13.8787 5.41602 10.8128 -9.57177 19.5795 +264 2 16.428 12.7198 4.52965 10.5011 -15.0883 17.3079 +265 1 6.17539 10.0558 0.19339 -10.2788 -9.80575 -26.1597 +266 2 5.38875 10.4515 0.589333 6.07089 -1.52504 2.9393 +267 2 6.86188 10.0925 0.84877 11.0601 2.17112 10.8149 +268 1 12.366 6.05676 4.0416 -22.1854 -19.7968 12.9024 +269 2 12.3704 6.78834 3.44644 3.0333 22.1434 -14.5586 +270 2 11.4296 5.77117 4.03801 16.8285 0.174707 3.6691 +271 1 0.132536 12.8255 0.204274 -0.526736 3.63462 -3.55478 +272 2 -0.0162245 13.5547 0.824079 2.12041 -2.82991 -1.20796 +273 2 18.2367 13.045 18.0704 5.31007 -1.26571 4.82883 +274 1 3.83823 18.58 8.61434 -10.0824 -4.97514 -18.4016 +275 2 3.52069 18.2861 7.74382 9.30441 -4.40092 2.94392 +276 2 3.03757 0.306881 8.974 -6.88025 7.19874 10.2509 +277 1 7.39362 17.2775 4.45212 12.7302 8.58303 13.7229 +278 2 7.99666 17.968 4.81801 -14.6435 -15.1886 -20.2263 +279 2 7.36047 17.3088 3.48385 6.79225 7.50625 8.12072 +280 1 9.21958 17.0373 12.2266 15.7968 3.09867 9.11932 +281 2 9.35553 16.2013 11.7334 2.65662 13.4997 9.89778 +282 2 10.0046 17.242 12.8046 -16.9951 -13.4125 -19.4407 +283 1 13.3157 13.0082 7.94027 -17.3901 -31.9016 7.67948 +284 2 13.1929 12.2449 8.54147 -2.27359 6.97807 -8.06923 +285 2 14.1396 13.3907 8.1966 15.275 17.864 3.60781 +286 1 14.9833 2.94943 15.3513 6.95235 -3.03472 -25.2367 +287 2 14.3042 2.39498 14.9448 0.627233 -0.993788 8.39197 +288 2 15.6656 2.99789 14.6444 -10.442 2.78752 17.6131 +289 1 9.85751 15.5027 17.0048 6.47201 6.54967 -7.92386 +290 2 10.2825 14.6779 16.7304 0.0104739 2.25127 2.62159 +291 2 9.29444 15.3215 17.7618 -3.54568 -3.88732 3.90928 +292 1 11.2881 8.2507 16.5469 4.08161 11.4658 1.26949 +293 2 10.784 7.71518 15.9432 -10.4144 -1.78397 -10.2593 +294 2 11.7122 7.60386 17.1014 6.56418 -3.83522 10.5232 +295 1 3.78473 18.1936 16.723 -4.68023 16.7202 -12.0174 +296 2 4.25527 17.5912 17.2966 7.9068 -1.91441 12.6846 +297 2 3.78787 0.451609 17.087 5.31404 -15.3334 2.54941 +298 1 2.1979 4.10843 8.95106 26.9406 -12.5237 33.2314 +299 2 3.04044 3.62982 8.81286 -17.1971 13.1508 -10.8815 +300 2 2.16124 4.09638 9.93984 -10.9226 5.8942 -24.7105 +301 1 9.90906 10.3512 9.74092 -24.4032 35.3078 2.18412 +302 2 9.42476 11.1784 9.45919 17.314 -27.1904 0.11143 +303 2 9.91744 10.4013 10.7102 5.12409 -5.92526 -7.2544 +304 1 9.73754 0.812356 10.8589 -9.45704 -2.93658 -4.01088 +305 2 9.44076 18.5949 11.1517 4.40065 -9.39685 13.0528 +306 2 9.08713 0.996724 10.1835 0.761981 14.6946 -8.69624 +307 1 9.19301 15.2105 10.2107 -22.2036 -10.0383 -7.82623 +308 2 8.98025 16.0713 9.80369 1.46967 -14.8527 4.99479 +309 2 8.36662 14.6679 10.1029 23.0402 13.9843 6.10558 +310 1 0.991303 9.28993 10.3284 48.5242 0.758788 -7.3086 +311 2 1.23965 10.2015 10.4879 -14.9681 11.3684 1.41472 +312 2 1.89881 8.9146 10.1688 -36.1698 0.796544 3.16897 +313 1 16.8183 4.88742 8.19443 14.5542 -10.1877 33.2312 +314 2 16.1728 5.34475 8.77937 11.7085 -6.30946 -17.3069 +315 2 17.4003 4.3619 8.8005 -18.9368 13.5764 -18.1776 +316 1 14.6428 14.6932 0.395223 -8.43601 -1.47433 8.87339 +317 2 15.0319 15.2579 1.0921 -3.12605 -9.09789 -8.18687 +318 2 13.8519 14.2576 0.787234 16.4944 11.1317 -8.84191 +319 1 3.51972 11.0527 9.63241 -0.0258339 11.398 -8.76826 +320 2 3.50143 11.4368 10.5206 2.13389 -0.105265 -4.21661 +321 2 3.1724 11.7459 9.02999 3.72912 -11.0816 8.2725 +322 1 11.0404 10.8634 1.27208 6.70694 17.4362 -9.49329 +323 2 11.1727 11.6824 0.735781 1.31404 -20.4369 14.6488 +324 2 10.1116 10.6362 1.15363 0.362803 -1.95542 1.92755 +325 1 13.2201 7.06705 12.8916 -20.9652 2.88797 -6.38338 +326 2 14.1438 6.85164 12.9216 15.9393 -3.58362 1.12932 +327 2 12.7477 6.22232 12.897 3.28641 3.49729 -0.863357 +328 1 9.62872 1.89177 0.948251 6.96093 0.24991 16.0649 +329 2 8.76715 2.00519 0.577625 -19.1552 -2.18542 -3.65809 +330 2 10.1854 1.76875 0.19003 12.4655 1.79214 -8.44775 +331 1 10.594 13.5319 4.7375 16.0423 -1.41644 13.6035 +332 2 11.415 13.0379 4.93682 -11.8157 3.93147 -13.4525 +333 2 10.5255 14.1008 5.52348 -3.94863 -4.31219 -11.1546 +334 1 14.2685 1.70153 10.8945 -3.08057 3.85383 7.15216 +335 2 15.0552 1.23258 10.5836 3.50278 10.8149 -1.53255 +336 2 14.4104 2.66429 10.8947 7.37053 -8.35752 -2.77651 +337 1 14.6611 12.4198 11.7249 1.4364 -26.5965 -56.3444 +338 2 15.4897 12.4837 11.202 -5.7241 6.85295 22.6084 +339 2 14.0924 11.9909 11.0313 1.01548 12.4899 31.9742 +340 1 8.24953 5.08668 9.79072 -30.3058 0.287699 22.814 +341 2 7.41708 5.03925 10.3073 16.545 17.0491 -5.32162 +342 2 8.22462 4.2143 9.42755 11.9131 -18.3304 -16.4659 +343 1 1.59402 16.8187 18.3253 -6.20255 31.6963 -6.78121 +344 2 1.91227 17.2067 17.482 -4.95179 -10.2412 13.7563 +345 2 1.83336 15.9037 18.3179 8.32765 -17.6711 -3.36436 +346 1 1.43897 17.2464 15.3358 29.6054 -7.17934 -6.21787 +347 2 1.36087 18.1379 15.637 5.97318 20.4573 7.89508 +348 2 0.556137 16.9475 15.3273 -33.612 -15.1267 -3.09538 +349 1 3.72895 5.57357 6.20543 -8.92972 12.8219 1.61975 +350 2 3.23079 6.21113 6.76482 10.0758 -7.74032 -14.0976 +351 2 4.28418 6.06511 5.5772 -4.67021 4.78615 6.0759 +352 1 12.3529 9.4251 14.1822 19.6727 -43.1834 10.5387 +353 2 12.884 8.61082 13.8993 -22.621 36.8155 4.19437 +354 2 12.0516 9.14148 15.0731 3.60544 11.6456 -14.396 +355 1 4.03531 15.2728 6.90881 24.4865 3.71204 -3.62934 +356 2 3.44033 16 6.68284 5.60112 1.73001 -3.29651 +357 2 4.96253 15.5542 6.68078 -28.8575 -4.96404 7.1648 +358 1 0.605953 8.56457 14.8638 -0.120582 -0.391313 3.99343 +359 2 0.501042 9.52227 15.005 5.35221 -7.46858 -4.68281 +360 2 1.25554 8.44629 14.1506 -6.09669 6.93914 6.70414 +361 1 12.9734 8.36578 10.3368 20.5003 -18.2509 -7.79226 +362 2 13.7393 7.86937 9.99522 -8.8873 10.1321 -9.444 +363 2 12.9708 8.03443 11.231 -10.3099 3.90117 14.6287 +364 1 15.2894 7.6332 3.49269 12.7581 18.2329 -13.143 +365 2 14.5338 7.17315 3.08677 6.1918 -0.800492 21.6775 +366 2 15.5136 7.51531 4.43453 -15.4019 -14.7068 -6.3771 +367 1 17.3212 6.64473 0.0316567 -27.1824 12.6283 -1.8657 +368 2 16.771 5.99448 0.499966 9.26154 0.672542 -4.32476 +369 2 16.64 7.24337 18.2783 17.9792 -11.5061 8.92142 +370 1 8.80668 6.92454 7.83918 -24.3908 -17.2325 7.20576 +371 2 9.68081 7.28212 7.80962 25.7376 5.86496 2.86911 +372 2 8.71775 6.37228 8.64787 6.10597 9.33115 -12.275 +373 1 12.3202 0.615137 1.17425 13.6931 -3.72396 -2.19539 +374 2 13.075 0.992886 1.63957 -0.40119 2.44364 5.09949 +375 2 12.7571 18.5667 0.666384 -10.9298 0.853201 -1.96514 +376 1 5.6785 15.1027 14.5126 8.23045 15.6484 -5.86338 +377 2 4.72039 15.1784 14.5966 0.299323 4.01186 0.94539 +378 2 6.04535 15.9236 14.1081 -12.4379 -14.8055 10.7649 +379 1 3.83406 6.52943 1.68496 -5.12703 10.9404 0.999964 +380 2 3.44824 7.31709 1.2662 3.88585 -11.3877 -2.55221 +381 2 3.84338 6.82178 2.59771 5.33619 -6.06857 7.79227 +382 1 3.88904 11.6132 12.2401 8.95627 -8.79814 -2.40389 +383 2 4.75841 12.0277 12.3683 -7.0992 0.0294616 4.018 +384 2 3.233 12.1226 12.7151 -2.84239 9.6423 6.84851 +385 1 5.44987 3.87776 15.8711 9.04603 51.7105 12.2927 +386 2 5.99752 3.20763 15.4917 15.5436 -17.9801 -7.19396 +387 2 6.04703 4.69158 15.9698 -28.7283 -34.9666 -5.01916 +388 1 14.4605 10.3225 4.39641 11.4537 -30.5762 -31.9722 +389 2 14.8306 9.83502 5.14205 -5.39586 2.29688 2.9797 +390 2 14.6901 9.75629 3.58792 -12.4512 26.4694 34.1579 +391 1 7.94485 17.2962 9.23406 -29.3852 32.3044 -4.90329 +392 2 7.20157 17.582 9.8013 11.6936 -12.8295 -3.21694 +393 2 7.93254 17.9646 8.52624 8.85814 -10.3239 0.926379 +394 1 4.49873 14.4249 3.9575 27.1774 17.1098 41.9883 +395 2 4.83669 15.3326 4.20793 -17.2661 -25.1881 -14.2087 +396 2 4.80599 13.8528 4.71739 -13.53 13.4591 -29.2523 +397 1 14.3284 7.3854 15.7629 16.5671 6.07561 9.97379 +398 2 15.2454 7.23106 15.4511 -19.609 3.15959 8.32151 +399 2 14.4426 7.80786 16.6389 -4.4507 -8.27801 -15.1382 +400 1 2.87403 18.2247 1.90389 13.9577 30.3231 32.1513 +401 2 2.546 17.6397 1.25326 -17.0615 -24.6646 -23.5795 +402 2 2.12038 18.5502 2.43008 9.19244 -2.23706 -9.85686 +403 1 7.96361 1.60549 4.53489 27.0952 14.1367 0.307488 +404 2 7.49638 1.9472 3.77739 -15.4877 0.180801 -4.55719 +405 2 8.8215 2.06687 4.46869 -11.5471 -13.5362 7.94734 +406 1 2.67177 14.1298 17.7578 -32.0965 -17.6674 6.84649 +407 2 1.82063 13.6639 17.9969 26.9839 12.0838 -7.18622 +408 2 3.38659 13.5743 18.1098 -5.52669 6.70603 -3.66321 +409 1 0.723551 1.68725 13.8621 17.7332 3.27009 -2.43746 +410 2 0.829271 1.51069 14.7908 7.98206 -4.95309 12.0999 +411 2 18.44 1.84118 13.7764 -20.4783 4.25661 -8.09669 +412 1 4.55406 18.6 13.9636 17.2604 -7.63309 -9.35161 +413 2 5.43897 18.1924 13.8214 -18.4623 11.1021 3.79828 +414 2 4.32329 18.399 14.8757 -4.15164 0.0521115 2.41255 +415 1 7.10455 0.474046 18.3679 -11.2359 27.2348 29.1061 +416 2 7.12016 0.115813 17.4965 -1.63433 -6.1865 -23.0052 +417 2 6.24271 0.910062 18.5515 12.5771 -12.8936 -7.91243 +418 1 16.1005 18.44 14.1333 -36.4501 -27.5791 -6.57953 +419 2 15.3829 17.8174 13.8465 25.6281 20.8019 -1.7164 +420 2 15.9077 18.5395 15.0719 9.49834 8.44163 -0.14337 +421 1 10.1046 4.52059 16.2893 -46.9792 2.1543 -16.8809 +422 2 11.0012 4.49779 16.5541 31.7343 -4.51398 5.87687 +423 2 9.86248 3.65729 15.9089 12.0807 6.21086 8.83226 +424 1 15.8363 17.9271 4.41684 -16.1004 8.03032 22.5493 +425 2 16.5039 18.6299 4.52246 -8.60661 -6.24751 -1.3813 +426 2 15.0378 18.2098 4.9532 29.0614 -11.0784 -22.6438 +427 1 6.9284 17.3613 13.7353 43.359 11.4946 7.60179 +428 2 7.46858 17.7163 14.5015 -21.3841 -13.8198 -23.6549 +429 2 7.59514 17.216 13.0184 -16.6797 3.36376 18.1603 +430 1 13.2847 6.56451 6.73769 -14.228 -11.1924 -15.3605 +431 2 14.2169 6.67596 6.68467 27.6084 8.49537 10.422 +432 2 13.086 6.40899 5.80997 -14.9004 -1.60425 -0.509451 +433 1 7.67719 2.38409 9.18276 -12.7481 -9.95901 -21.449 +434 2 7.23781 2.34079 10.0234 -2.84678 0.492631 19.9336 +435 2 6.97018 2.11077 8.55354 21.5545 6.86467 6.74712 +436 1 15.1528 14.8764 13.6487 -19.1236 6.62595 6.09279 +437 2 14.9964 15.042 14.5941 6.3649 -1.885 -8.0702 +438 2 14.3208 15.1168 13.2045 14.5757 -4.46306 2.19701 +439 1 9.29857 8.33432 3.70772 10.6355 -8.13532 4.49802 +440 2 10.1502 8.81328 3.76286 -8.0776 -10.0517 2.73632 +441 2 9.46492 7.39019 3.89736 0.427871 14.9166 -2.52044 +442 1 17.6858 13.4785 16.4504 18.1421 12.8824 -2.9019 +443 2 16.7336 13.3749 16.3876 -0.564153 6.32044 -4.53985 +444 2 17.9415 14.3223 16.0098 -13.7235 -15.3212 6.57805 +445 1 5.04165 10.6569 2.59879 15.0811 -13.5005 18.1704 +446 2 5.79991 10.2916 3.10884 -13.8602 3.81488 -12.1379 +447 2 4.57944 11.1735 3.25148 -7.64374 9.33605 4.93504 +448 1 3.71156 8.35988 10.3223 2.69392 -10.4458 7.32 +449 2 3.86762 9.29314 10.1995 2.90356 12.3134 -9.75827 +450 2 3.79851 8.25131 11.2818 -4.19061 -2.88345 -8.87222 +451 1 16.1009 7.11278 6.31821 6.57165 -19.5926 -13.3215 +452 2 16.7556 7.67982 6.75754 -3.32154 -9.30994 -6.24555 +453 2 16.5222 6.22545 6.20359 -10.7974 20.4957 5.39095 +454 1 15.1877 7.01217 9.11633 -0.942582 31.3193 -31.4924 +455 2 16.0087 7.4094 9.45282 -9.93766 -6.26011 -0.320925 +456 2 15.0368 7.51069 8.25256 3.47491 -21.9129 34.3614 +457 1 6.44498 13.1525 12.9077 -4.11711 1.46333 8.37594 +458 2 7.24124 12.6683 13.1519 -1.65948 -2.61146 -1.33868 +459 2 6.29723 13.796 13.6274 -0.63037 -8.66373 -16.4588 +460 1 12.122 4.49686 13.0678 27.186 16.1548 19.2119 +461 2 12.2551 4.61131 14.0219 7.12074 5.87928 -4.56992 +462 2 11.3374 3.99971 13.0395 -36.5276 -21.5475 -13.6693 +463 1 11.3413 8.18743 7.85231 -9.00357 4.77407 0.37365 +464 2 12.0188 7.6639 7.39095 2.25052 4.68793 14.2505 +465 2 11.6381 8.44006 8.74837 5.13859 -10.097 -12.5363 +466 1 17.1781 10.7776 7.41775 8.98079 -10.5429 4.93206 +467 2 17.827 10.053 7.20793 -14.7505 26.0455 -2.01259 +468 2 17.1485 11.4724 6.73654 6.61625 -12.2683 -1.04931 +469 1 5.23072 18.1435 11.0535 -19.1878 -10.0323 -1.26774 +470 2 4.70405 18.0783 11.8789 8.35901 -0.713622 -15.9457 +471 2 4.65273 17.8196 10.3204 13.2116 10.9899 16.482 +472 1 7.5638 17.6255 1.82385 0.18941 -4.57957 5.58349 +473 2 7.78527 16.8134 1.38126 5.66428 -18.4097 -0.230917 +474 2 7.45334 18.2192 1.09148 -1.66074 15.0057 -4.75644 +475 1 1.8616 12.9257 13.6096 9.14642 8.79388 9.51824 +476 2 1.6025 12.3584 14.3568 1.58601 7.25854 -8.04733 +477 2 2.19519 13.7677 13.9951 -8.21693 -20.1216 -3.01678 +478 1 9.73071 6.79429 14.803 -9.96431 20.7294 -5.24946 +479 2 9.965 5.93538 15.1079 4.49059 -29.2435 15.7374 +480 2 10.0131 6.81015 13.8895 1.7202 7.35701 -8.16934 +481 1 15.2073 4.3815 10.7753 5.02149 -7.87008 -1.3136 +482 2 16.102 4.07091 10.8622 12.544 -14.2164 -8.54624 +483 2 15.2461 5.11302 11.375 -14.5847 15.9831 9.57625 +484 1 11.1932 6.12384 0.161263 5.03411 2.82645 3.69768 +485 2 11.3288 5.17786 0.364595 -11.2178 11.9329 -9.49937 +486 2 10.2678 6.33084 18.566 9.25768 -12.2342 6.14633 +487 1 0.186838 11.3278 15.1363 -29.5173 30.1692 -23.1318 +488 2 18.3705 11.8565 14.4078 15.8912 -24.6881 20.4884 +489 2 18.5399 11.8236 15.9183 6.48048 -3.45982 -2.85079 +490 1 7.07004 9.14522 7.26474 -13.1186 -12.9635 8.90657 +491 2 6.53932 8.3872 7.60207 7.2147 19.6305 -8.47997 +492 2 7.95552 8.78183 7.22801 5.51641 0.721385 -0.901037 +493 1 18.4462 15.4465 12.3531 0.397712 -4.42488 4.01328 +494 2 0.764911 15.5581 12.2944 -10.8471 -1.16552 -3.91149 +495 2 18.1036 15.6779 11.4829 2.90793 1.2817 1.1609 +496 1 16.5729 4.36464 5.24677 -25.0478 -7.96005 29.4563 +497 2 16.6771 3.95228 6.15287 5.89012 16.1194 -31.2199 +498 2 17.3789 4.38374 4.73556 17.0857 -2.87844 2.77648 +499 1 17.7776 3.07164 10.7152 20.2072 1.91324 7.6701 +500 2 0.0768882 3.1314 10.9751 -16.1773 7.43675 -1.86825 +501 2 17.7244 2.20926 10.3009 -7.90603 -5.17093 -4.6179 +502 1 12.3097 0.0632784 10.17 -5.23585 14.9609 -0.662134 +503 2 11.3669 0.329281 10.3192 28.4735 0.874848 -0.34084 +504 2 12.8997 0.858518 10.2668 -24.0851 -21.9241 -3.33166 +505 1 10.3626 9.82488 12.3121 10.8795 10.4681 17.7395 +506 2 11.1241 9.87716 12.9295 -11.9387 -4.40292 -9.54779 +507 2 10.179 8.8911 12.2253 1.1465 -9.5921 -0.185536 +508 1 0.479623 2.83009 7.02164 2.3472 21.5918 -9.19818 +509 2 0.779466 3.61946 7.51564 -3.03286 -18.4976 -0.625243 +510 2 0.704445 2.06385 7.54355 5.66126 -3.27927 9.79357 +511 1 0.467007 15.244 6.91284 -2.81724 -38.2268 -9.44322 +512 2 0.589986 15.6097 7.78713 1.11258 -6.7374 10.833 +513 2 0.615386 14.2454 7.00377 -3.57496 47.8567 -6.78063 +514 1 16.9531 7.01102 15.3314 25.0955 -6.26352 -3.35293 +515 2 17.7312 7.54015 15.1398 -4.24099 15.1997 -5.49373 +516 2 17.3882 6.19624 15.5982 -13.584 -8.29127 -0.013797 +517 1 9.00968 12.4205 8.1448 -47.4595 3.97518 -14.6445 +518 2 9.255 11.8265 7.44329 24.3825 -11.7648 -7.05727 +519 2 8.04408 12.5071 7.93332 27.0995 7.32888 21.0703 +520 1 1.26609 1.94093 3.05591 2.05426 9.79258 -12.831 +521 2 1.21698 2.59367 2.33971 -7.6512 -12.9321 3.35408 +522 2 1.90984 2.32941 3.65026 1.81811 -2.05605 5.16186 +523 1 4.13335 15.1162 9.63732 -3.37236 0.94273 -0.929026 +524 2 4.11982 15.1465 8.67375 -6.81504 5.04573 1.04836 +525 2 4.9784 14.712 9.81623 8.98269 -4.0071 9.77097 +526 1 7.18021 2.17978 14.5671 7.55504 9.68183 9.47496 +527 2 6.93575 1.71258 13.7681 -0.50379 0.233559 -6.02908 +528 2 7.66352 2.97784 14.2972 -3.4628 -8.48803 0.116771 +529 1 18.6085 14.7119 2.15295 17.2538 -25.5542 -3.98016 +530 2 0.854482 15.0949 2.23403 -8.04084 1.8593 -0.311551 +531 2 17.9464 15.3611 2.33256 -11.9957 20.7574 3.41759 +532 1 9.94838 2.78838 12.9451 -1.38176 -12.4025 -13.9087 +533 2 9.76343 2.19068 12.1969 8.49761 3.03822 8.73498 +534 2 9.19943 3.38599 12.9407 -2.82035 8.06337 4.45668 +535 1 2.81023 8.91387 13.015 -11.0947 -9.09099 -1.03322 +536 2 3.12702 9.79437 12.8576 7.30933 17.7942 -2.89213 +537 2 3.52626 8.44288 13.432 10.5553 -8.83156 6.15268 +538 1 3.22981 8.35572 3.63929 7.91603 12.3414 59.3292 +539 2 3.55022 9.08279 3.12704 6.39159 12.4302 -19.4578 +540 2 3.47038 8.64809 4.58003 -14.7797 -20.4427 -37.089 +541 1 5.63158 7.19787 8.5111 -16.5836 -10.0318 8.45115 +542 2 5.49703 6.26423 8.32413 12.2862 -3.4998 -5.25722 +543 2 4.92977 7.35667 9.15199 5.58983 12.4707 2.72685 +544 1 14.8806 1.27947 2.01044 -5.20911 -29.6221 -13.7523 +545 2 14.8531 1.98102 2.64457 3.54145 24.2946 3.1913 +546 2 15.2413 1.51873 1.14568 -0.321243 12.6895 5.96264 +547 1 8.23741 15.1928 0.849855 10.5438 9.56485 -11.8122 +548 2 9.03414 15.1092 1.40038 -9.07879 -4.36113 3.60062 +549 2 7.50349 14.6875 1.21874 4.98636 -2.78068 7.26539 +550 1 15.6325 1.34538 7.23629 -19.2726 -10.6819 -7.69516 +551 2 14.9548 0.715658 6.87861 16.0521 20.279 9.35294 +552 2 15.1584 2.15623 7.4957 0.78871 -9.00488 -4.70177 +553 1 4.90948 13.0908 18.526 11.7484 -4.19917 14.2638 +554 2 5.32661 13.1046 0.771936 -5.81675 2.26251 -17.1314 +555 2 5.47193 13.6353 17.9612 2.08739 -3.03703 1.40027 +556 1 15.3444 8.47528 18.1477 10.5782 11.2904 -17.9652 +557 2 15.7712 9.10441 17.5134 -10.1785 -13.1115 16.9911 +558 2 15.2549 8.94211 0.342082 0.277618 5.95495 -1.45242 +559 1 12.072 3.0348 18.3713 9.16845 -16.043 3.97866 +560 2 11.9997 2.53228 0.532204 -11.5106 10.3924 18.501 +561 2 12.5782 2.36842 17.9104 5.62845 7.32417 -26.0863 +562 1 13.2089 12.6783 5.18015 6.63876 -6.29032 2.85699 +563 2 13.7391 11.9795 4.78379 -2.73226 -0.00342211 -8.22979 +564 2 13.3831 12.5487 6.11225 -3.40081 8.86391 8.40941 +565 1 6.04915 7.04527 0.0350485 10.8742 -21.2203 -4.52865 +566 2 6.02805 7.99092 18.6226 -5.46576 23.9499 6.727 +567 2 5.33859 6.76219 0.618839 -5.51003 3.35157 1.33709 +568 1 17.7393 16.0214 15.0094 13.9302 -13.9422 41.059 +569 2 16.9573 16.5339 15.2303 -2.65419 1.12677 -17.6965 +570 2 17.9199 15.9264 14.0844 -11.8828 6.17072 -25.9912 +571 1 13.1897 1.00209 16.5482 9.0285 -11.9403 8.82412 +572 2 14.1531 0.926941 16.6936 -12.5978 2.36886 -2.70952 +573 2 12.8801 0.0805392 16.5939 -0.793518 8.62378 -3.88342 +574 1 11.1147 14.5676 7.20714 13.0879 22.2032 -16.1382 +575 2 10.392 14.3041 7.74555 -20.7251 -13.6554 17.189 +576 2 11.8256 13.9392 7.33494 4.5733 -4.90634 5.95678 +577 1 17.5119 8.63301 2.08454 0.0660302 9.5119 10.6671 +578 2 16.6736 8.51459 2.527 -7.33525 3.37542 8.64387 +579 2 17.5132 7.89769 1.49414 7.23803 -17.2019 -20.825 +580 1 12.3543 7.99739 2.01665 -2.5776 9.38468 -13.8973 +581 2 12.1955 8.87571 1.62365 2.26325 -8.37679 12.9533 +582 2 11.9634 7.39841 1.37453 -1.21895 -7.08079 -1.91625 +583 1 11.8862 14.6191 10.3431 -20.5633 -33.2885 -21.2052 +584 2 12.048 13.7971 9.8109 4.18347 28.6601 18.3667 +585 2 10.9021 14.6739 10.3387 21.4811 7.86907 3.51893 +586 1 6.88785 7.04202 15.6064 18.5625 21.2571 16.3476 +587 2 7.79496 7.28653 15.325 -16.282 -10.9681 -3.58347 +588 2 6.76913 7.58838 16.4136 -4.66142 -14.4555 -17.927 +589 1 8.00173 4.72633 13.4744 30.8534 11.0647 12.2619 +590 2 7.23536 4.76996 12.9314 -21.7993 1.23146 -17.3356 +591 2 8.43981 5.59806 13.3773 -8.25054 -18.6352 3.63378 +592 1 13.408 12.1818 14.2607 -3.38159 -13.7589 -5.77775 +593 2 13.0599 11.273 14.209 4.17969 5.9499 4.9999 +594 2 13.8015 12.3234 13.3884 0.552928 6.09909 4.73433 +595 1 14.8332 9.42219 7.30259 -3.18701 -8.441 -7.55641 +596 2 15.6639 9.86655 7.42287 15.173 5.4083 -0.0492361 +597 2 14.1987 10.0431 7.62107 -17.8235 6.30723 6.71627 +598 1 12.6528 17.0596 3.07812 -8.70602 18.4808 5.33985 +599 2 12.9496 17.4673 3.92869 -9.46791 -7.74089 -22.4319 +600 2 12.0101 17.6853 2.63014 23.5323 -19.7514 22.4129 +601 1 1.16198 7.14088 17.4585 -7.06812 8.47411 -13.2553 +602 2 0.305081 7.19087 17.9183 5.00325 -4.47293 -7.14563 +603 2 1.04973 7.54449 16.5661 0.440843 -6.25707 18.2149 +604 1 12.7703 5.1502 15.6519 20.537 -9.206 9.03076 +605 2 13.4569 4.49661 15.9358 -13.2491 19.9411 -11.3493 +606 2 13.2029 6.02791 15.5919 -0.675517 -15.6076 2.74775 +607 1 2.52973 3.39372 4.98628 -12.5021 24.9114 40.8727 +608 2 1.78336 3.12225 5.60975 27.8197 11.256 -19.0698 +609 2 2.94772 4.23746 5.36491 -19.3389 -38.1774 -13.5008 +610 1 8.3189 11.2987 13.4496 33.0028 -42.3062 59.2485 +611 2 8.52043 10.9592 14.374 -32.1909 27.8732 -26.3694 +612 2 9.06111 10.8351 13.0577 -1.72326 7.29715 -30.1092 +613 1 12.8789 1.33643 13.3362 0.40834 22.0058 -3.21803 +614 2 13.4118 1.44301 12.5159 -13.2456 3.30889 14.5055 +615 2 12.3632 2.16071 13.5095 17.0122 -18.2145 -15.4576 +616 1 6.34323 13.7037 2.15004 -8.90275 3.4942 1.01633 +617 2 5.67068 13.9831 2.80896 17.8093 -8.54249 -8.97759 +618 2 6.94017 13.0667 2.55763 -1.44693 0.407866 6.84109 +619 1 15.9207 6.60938 12.7941 -14.0219 -16.6873 -1.46208 +620 2 16.3665 7.21966 12.2297 10.4548 13.0291 -14.3606 +621 2 16.4032 6.61209 13.6164 4.57404 0.312906 11.3916 +622 1 16.837 0.713429 9.59537 -4.60186 -23.2491 -5.40047 +623 2 16.7766 18.3812 9.76009 1.861 23.059 -1.51736 +624 2 16.4539 0.846132 8.70764 2.52408 0.807103 8.64662 +625 1 6.14677 11.7538 8.37929 1.46343 -38.2042 -1.58984 +626 2 5.28119 11.5099 8.79312 19.6536 2.3972 -11.55 +627 2 6.62627 10.8955 8.13754 -23.51 30.7545 10.2414 +628 1 2.89887 8.61954 0.44521 -58.0253 1.44029 -30.8084 +629 2 2.28026 8.19904 18.4406 35.2092 -5.33136 7.34884 +630 2 2.23436 9.22701 0.790296 19.604 11.6332 17.9417 +631 1 10.1646 10.4607 6.5042 -2.67562 1.82661 -6.4385 +632 2 10.6119 9.73033 6.95167 0.990091 1.19991 -1.59039 +633 2 10.4858 10.4732 5.58284 -1.09389 -1.85789 13.424 +634 1 6.73063 15.6946 6.55447 -0.851851 -4.83477 5.20485 +635 2 7.09829 16.1491 7.32752 1.36873 0.436433 -10.1699 +636 2 7.02842 16.1335 5.74515 1.47904 6.69628 7.42626 +637 1 6.44804 13.1708 5.58287 -3.43311 -13.1021 10.8705 +638 2 6.66139 13.9646 6.07673 2.2473 5.97996 0.728386 +639 2 6.06157 12.5687 6.2363 0.868112 2.44944 -5.20285 +640 1 16.8203 12.5595 9.83963 -1.29973 -13.3798 -26.0882 +641 2 16.9797 11.9255 9.1094 -0.187484 2.38257 16.1818 +642 2 16.6351 13.3676 9.36293 0.809528 9.54538 5.72824 +643 1 6.04152 2.95052 2.84999 -1.13024 -25.4835 15.2707 +644 2 6.4006 3.79327 2.62573 5.01416 22.8678 -12.9444 +645 2 5.58314 2.5656 2.09763 0.434854 2.67004 -8.58918 +646 1 10.9107 3.32852 3.29939 -12.4238 -2.51051 -2.149 +647 2 10.2568 3.99067 3.55961 5.98057 0.0707186 3.553 +648 2 10.4887 2.88551 2.55708 3.841 -3.98893 -4.96007 +ITEM: TIMESTEP +20 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.69334 7.07477 17.9589 0.0661907 -8.15672 -5.93801 +2 2 7.76544 6.892 18.1438 2.06168 0.344835 4.67083 +3 2 8.87494 6.58302 17.1494 0.0923072 2.18051 2.08263 +4 1 18.5724 8.27759 6.8487 9.68108 -9.0135 5.9796 +5 2 0.0748736 7.96696 5.95521 0.0469709 2.78304 -15.7461 +6 2 0.399795 7.62446 7.38749 -2.21574 6.41883 6.02377 +7 1 8.4 18.5641 6.8134 3.87483 8.82198 -0.0595031 +8 2 9.32611 0.166963 6.70047 -3.24105 -1.28376 -0.166563 +9 2 7.89494 0.641414 6.41149 2.5055 -2.76566 0.153015 +10 1 6.59225 1.83896 11.6912 -0.275689 0.302437 5.80014 +11 2 5.92509 2.27303 12.2308 -4.07131 5.9643 -4.10931 +12 2 6.1821 1.00166 11.4658 -1.55571 -7.95905 -4.17259 +13 1 7.1255 5.73378 2.34451 -23.1841 27.0209 10.5427 +14 2 6.64356 6.29382 2.99422 10.5833 -21.9235 -2.45439 +15 2 6.93596 6.23963 1.54379 8.61204 -12.4491 -6.79559 +16 1 16.2118 10.162 16.1238 9.73263 11.3036 -6.58381 +17 2 17.0956 10.2901 15.7587 -2.05967 -6.96031 3.12171 +18 2 15.9212 11.066 16.279 -7.86411 -1.51367 3.55804 +19 1 10.6155 15.0016 2.3147 2.6864 2.11515 1.56294 +20 2 10.6002 14.5314 3.15674 -2.41534 -3.03603 0.679536 +21 2 11.0785 15.8209 2.51731 -0.0195897 0.981381 0.0978469 +22 1 17.1585 8.25197 10.4305 1.44624 0.93325 5.78222 +23 2 16.6499 8.94547 10.8694 -0.557047 -3.86734 3.9084 +24 2 18.0092 8.65295 10.2197 -0.225121 0.250414 -1.13708 +25 1 14.8741 15.8852 16.3481 -7.08493 -6.82471 0.413246 +26 2 13.9679 16.1979 16.3007 -7.09092 5.8218 -2.34027 +27 2 14.8494 15.2418 17.0641 6.82868 3.48864 5.90805 +28 1 12.1588 13.3817 0.433178 -6.27467 12.7595 -4.80914 +29 2 12.0352 13.6324 18.1551 4.79076 -7.76922 -3.88045 +30 2 11.6846 14.0735 0.910169 -3.08866 -6.36125 10.7585 +31 1 9.27449 5.40778 4.04397 -13.9365 -16.0184 3.55858 +32 2 8.80012 5.02015 4.81047 7.30704 13.9384 -9.37026 +33 2 8.62496 5.33174 3.3181 9.32114 8.483 4.67507 +34 1 1.82732 4.26294 11.6464 -4.04254 -2.69427 0.93532 +35 2 1.77693 5.20244 11.8864 -0.000737327 -7.07977 -0.141665 +36 2 2.24287 3.78422 12.3753 -0.858945 2.71416 -2.4423 +37 1 1.98268 6.82933 8.36887 -4.76513 2.22844 -15.7156 +38 2 2.36253 7.23451 9.15103 4.34961 -4.46197 5.21996 +39 2 2.01952 5.87123 8.47722 1.07428 0.125821 9.68028 +40 1 5.39566 4.39684 7.93565 8.0799 8.40992 8.79829 +41 2 5.46014 3.43633 8.01893 -3.87159 0.552259 -10.4859 +42 2 4.76986 4.63893 7.2446 -2.8004 -4.28351 -0.196723 +43 1 3.26324 2.92599 17.538 -6.48526 11.4036 5.90093 +44 2 3.9521 3.41084 17.0519 -4.33162 -2.5567 2.49087 +45 2 2.74469 3.58038 18.0606 14.1441 -6.64194 -12.4081 +46 1 7.47828 5.27232 6.10849 -6.04695 1.38866 -9.34596 +47 2 7.88111 5.94624 6.68322 -4.96979 -11.9122 3.47667 +48 2 6.82246 4.73008 6.58045 9.57964 11.031 7.72945 +49 1 9.77144 7.02208 11.9904 4.73189 -1.1383 -1.06285 +50 2 10.3467 6.38126 11.5734 3.30689 -2.46386 0.831607 +51 2 9.14216 7.24941 11.3005 -7.52384 3.80108 0.31383 +52 1 14.0798 3.55416 8.05513 -3.28328 4.35009 -1.93857 +53 2 13.7004 4.26501 7.52877 0.673114 -0.544944 -0.0617854 +54 2 14.5392 3.99696 8.77439 -0.252332 -0.945414 2.55344 +55 1 4.73763 17.2389 4.01031 -0.321378 8.61877 -17.0141 +56 2 5.59566 17.6635 4.11691 -0.835388 -5.76098 7.55997 +57 2 4.38449 17.6475 3.19969 -7.45685 -7.93836 11.3283 +58 1 16.5107 16.6056 10.0759 6.54448 8.81329 9.76337 +59 2 15.9397 16.7408 10.8388 -5.01232 -5.78767 -1.53078 +60 2 15.9723 16.2069 9.3894 -4.78788 -4.31379 0.495659 +61 1 1.96746 4.90416 0.450775 -1.81832 7.5424 0.20662 +62 2 2.57813 5.33173 1.07474 -1.76589 -7.7088 -3.71938 +63 2 1.58349 5.65244 18.6136 5.80255 -6.17515 -0.843526 +64 1 11.7761 13.343 16.2841 -6.04701 8.80367 11.8739 +65 2 11.2992 12.5177 16.4849 4.5736 1.77316 -11.3497 +66 2 12.2862 13.2596 15.4658 -7.12668 -12.5479 1.29578 +67 1 10.1128 11.0591 16.9331 1.69597 -16.074 1.546 +68 2 10.529 10.1874 17.0807 -3.30995 11.3925 -3.21813 +69 2 9.18388 10.849 16.7697 3.68635 3.27029 -1.84825 +70 1 11.7127 17.5197 13.4648 11.3019 2.11475 -5.22831 +71 2 12.331 17.0869 12.8651 -0.203424 -4.77186 2.96515 +72 2 11.9976 18.4453 13.422 -5.71015 -0.897636 4.76739 +73 1 6.35333 9.30557 12.2266 11.9787 8.60001 -4.91149 +74 2 6.91868 9.08658 11.4768 -7.06745 -10.6307 -2.02859 +75 2 6.87303 9.9972 12.642 -2.68502 3.03115 9.09234 +76 1 16.2229 12.7446 2.69624 -0.291567 -17.1772 2.14859 +77 2 17.0444 13.127 2.38556 1.82795 9.93981 0.639945 +78 2 15.5737 13.4355 2.84522 -0.398116 10.9003 -3.52894 +79 1 0.630414 12.571 5.87324 -2.78001 5.23525 -2.09291 +80 2 1.00794 12.4159 4.99822 -5.49855 2.79722 0.151968 +81 2 18.3568 12.8603 5.70082 10.405 -7.04854 2.54099 +82 1 5.20787 16.4001 18.4776 -12.5497 0.602195 -7.10426 +83 2 5.86464 15.8156 18.076 4.18722 4.70251 6.39081 +84 2 5.5918 16.9091 0.552483 9.38889 -4.76533 -0.723228 +85 1 0.52849 7.63403 4.08589 29.1287 17.8407 -12.6947 +86 2 18.5836 7.90722 3.36083 3.6478 2.13346 8.06342 +87 2 1.42012 8.03877 3.86645 -30.4536 -16.431 6.17599 +88 1 3.1381 8.91119 6.51072 -13.5755 -1.26875 13.9192 +89 2 3.59199 8.61596 7.312 -0.196935 0.713487 -8.34602 +90 2 2.19086 8.84537 6.73861 12.9731 1.00292 -6.41375 +91 1 7.31254 10.3111 16.1924 3.71601 3.69021 9.41051 +92 2 6.5835 10.5117 15.6001 -2.45726 -1.05124 6.16708 +93 2 6.97924 10.3433 17.1122 -4.5268 -1.10556 -13.1914 +94 1 11.1003 1.05051 4.99797 5.80988 -5.62906 14.1745 +95 2 11.3837 1.86623 4.56736 -9.38615 -1.44268 -8.87945 +96 2 10.7526 0.427875 4.34338 1.37635 7.2616 -4.61902 +97 1 4.41216 2.72626 13.196 4.39031 -15.812 27.2385 +98 2 4.68873 3.14242 14.0209 1.29771 13.5884 -6.24163 +99 2 4.35373 1.80262 13.5146 -5.93981 4.62314 -19.463 +100 1 8.39633 10.0477 1.8021 8.65231 5.58991 3.9521 +101 2 8.43584 10.7505 2.47552 -3.18527 -5.8592 -1.95349 +102 2 8.78245 9.25294 2.20632 -6.17245 6.11296 -0.869653 +103 1 10.5167 1.74791 15.5607 -12.987 -0.969766 6.95693 +104 2 11.4294 1.4693 15.6846 2.64548 4.13814 -6.20872 +105 2 10.3497 1.97094 14.6365 5.88046 -1.13362 -2.56443 +106 1 2.75172 12.9341 7.77038 -1.98364 -2.25212 -7.11701 +107 2 3.34024 13.5411 7.30753 1.72417 1.81116 5.40918 +108 2 2.20386 12.578 7.06153 -5.53374 1.90184 4.06344 +109 1 3.65904 11.6762 5.27167 1.4745 3.00351 -5.43274 +110 2 3.4246 11.0613 5.97769 -1.9036 -0.651658 -6.95213 +111 2 2.87422 11.8691 4.73548 4.37313 -4.77202 2.40024 +112 1 6.8497 14.4837 16.8623 -7.20011 -2.9268 7.54224 +113 2 7.64382 13.9472 16.8068 -1.68272 1.48794 -3.62778 +114 2 6.45279 14.5388 15.9848 5.36951 2.03983 -1.60361 +115 1 14.1732 14.5515 3.40534 8.00808 -4.71428 -5.83886 +116 2 13.686 15.3662 3.26714 -6.11485 0.946493 -0.0166146 +117 2 13.6673 13.9759 3.98664 -1.2314 3.40033 5.39954 +118 1 8.29912 18.1674 16.0589 -20.5282 -4.34905 -0.197762 +119 2 8.7408 17.3576 16.3653 13.9085 14.9544 -3.06277 +120 2 8.83266 0.312858 15.8727 12.6636 -13.3116 3.05514 +121 1 4.73053 1.62244 4.91728 3.73461 17.8941 -9.82498 +122 2 3.87083 2.07692 4.90413 8.70323 -5.84393 3.64668 +123 2 5.31846 2.19299 4.38363 -11.3635 -9.88313 3.69576 +124 1 15.0998 12.7921 16.4359 -16.5392 5.6559 5.83964 +125 2 14.613 13.1569 17.1797 9.93151 -3.40376 10.0434 +126 2 14.4182 12.7815 15.762 4.3611 -9.31248 -14.0367 +127 1 15.7898 18.3971 16.8042 5.79346 -1.22695 27.8179 +128 2 16.3329 18.5498 17.6117 -9.65553 4.21222 -20.1346 +129 2 15.4648 17.4968 16.9407 3.00983 3.14177 -9.23088 +130 1 1.14588 1.15091 16.5513 6.84042 -4.63386 -6.55399 +131 2 1.94328 1.67743 16.706 -5.62204 0.173811 5.06431 +132 2 0.528577 1.37004 17.2554 5.0728 5.5861 0.922174 +133 1 18.0913 4.5707 15.884 4.25376 -5.47852 -1.15194 +134 2 18.5654 4.01411 15.2573 -2.45188 0.25544 1.09753 +135 2 18.6545 4.64521 16.6589 -1.38654 0.113736 -2.45626 +136 1 12.2253 16.9711 16.1412 0.914186 -11.4555 3.91466 +137 2 11.5632 16.3741 16.5429 5.70701 14.4982 -7.43821 +138 2 12.0767 16.9746 15.1851 -6.52552 1.11271 2.73005 +139 1 15.9091 2.53324 17.9911 -0.813861 17.5084 -1.21546 +140 2 15.6764 3.36649 18.4268 1.17892 -6.2644 3.50604 +141 2 15.6868 2.72575 17.0644 4.5424 -10.5093 4.50867 +142 1 6.70264 13.8034 10.241 3.67042 13.5267 -3.47207 +143 2 6.65382 13.63 11.1889 -2.71481 -10.4168 -1.32753 +144 2 6.64075 12.981 9.74212 -1.13183 -3.39045 4.84834 +145 1 10.1303 18.2368 2.79334 3.88934 4.25391 -9.05815 +146 2 10.3528 0.228802 2.09034 -3.74927 -2.61302 6.3793 +147 2 9.24556 17.9143 2.58077 2.23777 4.46644 1.38681 +148 1 2.97822 17.7592 6.09436 6.84514 -11.0569 -16.6755 +149 2 2.2147 17.6257 5.53291 -18.2595 3.26089 9.16469 +150 2 3.66284 17.6557 5.427 11.9633 8.77303 4.67614 +151 1 12.5626 16.9639 7.98676 12.5848 -1.11028 -8.52053 +152 2 11.8839 16.2724 7.94525 -2.9484 9.81966 4.92503 +153 2 12.3706 17.6612 8.63222 -7.85492 -11.7975 4.91014 +154 1 14.885 15.2749 8.26678 1.09184 -13.1129 19.8008 +155 2 14.1202 15.8628 8.27106 1.10724 6.83397 -10.769 +156 2 15.4286 15.3633 7.48102 -5.52588 8.50153 -14.3957 +157 1 17.5862 18.2834 0.376986 -24.9344 -1.23553 -1.17468 +158 2 18.3469 17.8479 0.005767 18.8411 -2.89863 0.907383 +159 2 17.8259 0.448151 0.831731 10.0339 0.947456 -0.506579 +160 1 0.885899 10.3809 1.40397 7.22911 -11.5028 6.53987 +161 2 0.114071 9.81378 1.55479 0.851643 9.57639 -0.353744 +162 2 0.635753 11.1007 0.824785 -9.84019 7.34982 -5.0696 +163 1 1.59112 12.2023 3.3355 8.42913 -7.93475 21.5428 +164 2 1.38243 11.4488 2.766 -0.926106 10.11 -6.99043 +165 2 1.6499 13.0233 2.84482 -2.64968 -0.879455 -11.853 +166 1 0.551086 17.2511 4.8776 21.276 -3.63263 -24.3978 +167 2 -0.0762795 17.9651 4.97462 -6.3407 4.63135 13.3725 +168 2 0.558623 16.612 5.58807 -10.7338 -2.48853 14.1039 +169 1 1.11389 0.976548 9.40441 -9.70348 2.26791 0.52143 +170 2 1.20067 0.739298 10.3296 11.5619 -5.66825 6.05541 +171 2 0.194683 0.747268 9.24308 -0.993818 -3.51563 -8.196 +172 1 16.7801 2.33697 13.2827 1.26658 -2.58515 -3.42214 +173 2 16.9917 2.52603 12.3542 -2.2694 -1.44301 7.47438 +174 2 16.5315 1.40163 13.3451 -1.6586 3.84983 -3.29893 +175 1 2.50653 15.8317 12.198 6.9942 0.0378495 -5.39106 +176 2 3.03319 15.4932 12.933 -2.33393 0.151651 -5.20129 +177 2 2.92041 15.5438 11.3652 -1.63849 1.19534 6.62391 +178 1 16.4211 15.5676 5.95733 20.9565 28.2944 1.83954 +179 2 17.3426 15.5843 6.27645 -8.81355 -7.9692 1.26231 +180 2 16.3612 16.4166 5.46885 -9.28613 -17.0928 2.60564 +181 1 5.82453 5.03389 11.7824 5.33446 0.320875 1.57619 +182 2 5.57998 5.74431 12.3877 -7.39983 3.16893 -2.12011 +183 2 5.27405 4.27426 12.0034 -1.54313 1.61628 -0.196815 +184 1 15.2115 4.85871 0.718957 -12.3292 -1.21553 20.1953 +185 2 14.9951 4.64926 1.65891 1.99725 2.35951 -19.8125 +186 2 14.3839 5.18637 18.9796 8.05664 -2.8997 2.32554 +187 1 16.3489 16.3233 2.11444 -1.37403 -13.232 -8.15517 +188 2 15.9103 16.7203 2.87049 4.10511 7.42013 3.0617 +189 2 16.5474 17.0218 1.48672 0.743353 6.63736 2.3016 +190 1 0.282027 4.87119 3.80055 19.2835 17.3487 3.53091 +191 2 0.489613 5.83173 3.76503 -11.8967 -17.4303 3.14809 +192 2 1.11089 4.48306 4.11838 -9.18259 -2.61174 -2.176 +193 1 2.9303 15.0125 15.0392 0.0573492 -0.181072 31.7668 +194 2 2.82615 14.584 15.9186 6.41531 2.15453 -14.4377 +195 2 2.5906 15.8967 15.228 -6.81336 0.182398 -11.4579 +196 1 1.12223 14.6049 9.5632 13.1187 -18.7351 -0.898815 +197 2 1.97867 14.3698 9.19328 2.71847 14.7063 -6.21023 +198 2 0.940175 13.7592 9.98602 -14.9991 7.00648 6.43026 +199 1 13.665 16.6454 11.5316 -21.8339 3.0331 3.55613 +200 2 13.1746 17.4327 11.223 10.4467 -7.06131 -5.36321 +201 2 13.1002 15.9021 11.2581 8.49503 1.30575 -4.9094 +202 1 4.71709 1.47693 0.719081 -0.792104 -2.26487 7.67979 +203 2 4.13723 2.08795 0.242023 0.0358417 -6.61504 -0.0652634 +204 2 4.16248 0.903426 1.27536 -1.89276 3.42768 -9.42283 +205 1 1.43372 18.4947 11.8904 0.435024 0.903574 -5.06079 +206 2 1.25876 0.369488 12.6813 0.171373 0.403899 4.07674 +207 2 1.76959 17.6363 12.1756 0.0129122 3.12302 0.145238 +208 1 11.5344 10.1145 4.09755 11.0508 4.0163 -22.2825 +209 2 11.4066 10.5292 3.21014 2.38528 -6.34716 18.1192 +210 2 12.5036 10.0411 4.22804 -15.2135 3.993 -1.98571 +211 1 8.36281 12.1777 3.74701 -13.1943 -6.81146 -12.1909 +212 2 9.18722 12.6378 3.9579 -8.09176 1.3179 12.2751 +213 2 7.70079 12.2682 4.46238 18.0882 5.10492 -3.45512 +214 1 14.3344 4.02288 3.28855 15.2498 3.93213 6.6836 +215 2 15.0617 4.23514 3.91062 -12.0049 -4.72392 -3.76747 +216 2 13.5379 4.47251 3.60621 4.75183 0.0120405 -3.02562 +217 1 5.58434 1.74596 7.50985 -22.3692 -26.8297 9.12948 +218 2 4.91823 1.11394 7.92632 27.2868 23.8434 -15.8784 +219 2 5.43743 1.67946 6.54893 -3.28939 1.24453 9.56906 +220 1 17.9012 1.11073 4.88195 -3.31078 -7.47428 -4.80941 +221 2 18.5525 1.45486 4.25184 -3.70144 3.91348 6.86656 +222 2 17.7599 1.74881 5.59037 4.24211 2.13046 -3.7457 +223 1 6.8304 9.4053 4.48372 -13.6803 0.789023 -7.06041 +224 2 6.74666 9.48009 5.43928 9.48337 1.88908 4.46236 +225 2 7.74899 9.21301 4.27057 2.55497 -2.6247 5.048 +226 1 2.68932 14.9418 1.9668 -6.12139 1.43036 2.89635 +227 2 3.30587 14.7185 2.6759 1.77318 0.618157 -6.66396 +228 2 3.15681 14.9246 1.12432 2.70839 -4.47578 5.21755 +229 1 17.2859 12.889 13.1454 -5.46423 18.1991 -4.92566 +230 2 16.4361 13.3067 13.278 -15.9577 -14.9195 9.16742 +231 2 17.7285 13.6846 12.8505 24.3586 -1.49654 -2.29875 +232 1 15.0069 10.5712 1.38624 -2.11062 -3.1818 -0.491761 +233 2 15.5786 11.255 1.74854 2.03128 0.359313 2.4477 +234 2 14.2323 11.0405 1.08579 -5.34855 2.20107 -0.889893 +235 1 5.70672 6.90314 4.53443 4.24519 -5.28557 8.89432 +236 2 5.96576 7.83558 4.52332 0.860976 -3.32444 -1.54743 +237 2 6.34045 6.45199 5.11743 -0.773999 0.740319 -5.54545 +238 1 8.07933 8.28074 10.2171 -3.64639 -3.67369 23.1077 +239 2 8.76707 8.87858 9.90894 -2.7343 3.77639 -10.7375 +240 2 7.6749 7.81667 9.48055 2.86655 5.40525 -7.79011 +241 1 13.5084 18.3075 5.79227 -0.609935 12.5659 -0.945985 +242 2 12.8781 0.387145 5.63591 -2.7451 -9.905 0.332396 +243 2 13.1846 17.8335 6.57076 -1.7745 -1.29433 -5.46225 +244 1 0.277736 2.58212 0.118598 0.621477 -2.00702 8.56184 +245 2 17.957 2.7127 18.6839 10.2871 11.0559 -0.501636 +246 2 0.794319 3.38844 0.33639 -19.4232 -4.52538 -3.88061 +247 1 12.6801 10.9983 9.7602 -12.9965 -11.6862 -0.561246 +248 2 11.7228 10.8953 9.6485 6.19444 12.5166 -3.56604 +249 2 12.897 10.0826 9.9647 14.0656 0.707903 4.64438 +250 1 0.781933 12.2574 11.0872 -6.04901 -2.18816 6.07288 +251 2 18.4712 12.3682 11.1342 -4.62852 -2.97634 -7.25325 +252 2 1.06266 12.4852 11.9795 7.76729 1.60409 -2.26455 +253 1 5.05561 7.24886 13.466 -11.4852 -6.03635 -4.86876 +254 2 5.50236 8.03712 13.1394 10.7241 -0.576345 -1.34855 +255 2 5.49314 6.97472 14.2774 5.89817 7.37955 3.96262 +256 1 1.26581 6.94402 11.8396 4.62667 -0.613543 7.50244 +257 2 0.504801 7.20295 11.3208 -2.84364 2.86798 -1.49635 +258 2 1.66495 7.76854 12.1529 -2.34869 -3.61795 -5.23307 +259 1 15.4733 9.48228 12.3076 -4.70583 25.6475 16.0975 +260 2 15.3149 10.4406 12.4106 2.52372 -12.0579 -11.0564 +261 2 15.3983 9.16189 13.2139 2.67764 -6.7615 -6.72177 +262 1 16.6336 12.9201 5.4628 6.66579 -20.8603 16.0577 +263 2 16.5173 13.872 5.54201 -7.55482 0.841067 -13.5204 +264 2 16.4587 12.5944 4.56908 -1.3904 13.4091 -1.6671 +265 1 6.18458 10.0203 0.145227 10.7922 -3.52818 2.39688 +266 2 5.51531 10.431 0.700604 -4.05423 0.759005 -2.7608 +267 2 6.99302 10.1148 0.667984 -1.67417 -4.19008 -1.28624 +268 1 12.3589 6.06668 4.038 0.452115 -1.15559 12.336 +269 2 12.2616 6.902 3.56852 -2.7325 -0.676505 -9.18667 +270 2 11.4806 5.67315 4.10483 0.607886 2.8799 -4.57435 +271 1 0.151536 12.8218 0.203335 4.13456 -2.94622 -2.33064 +272 2 -0.0129983 13.5003 0.871422 4.06521 1.52419 -2.90371 +273 2 18.34 13.1254 18.0507 -1.07008 -0.669132 2.22617 +274 1 3.8124 18.585 8.59267 3.71655 -0.510361 5.11861 +275 2 3.56708 18.0759 7.80793 -6.58546 5.02297 1.51156 +276 2 3.01311 0.371537 8.92178 -4.29721 -3.94788 -5.16471 +277 1 7.41673 17.2735 4.46563 5.27699 16.8729 -12.8498 +278 2 7.96434 18.0381 4.66458 -2.5447 -1.66977 13.1327 +279 2 7.34622 17.3735 3.5102 -3.86431 -11.0257 -0.167405 +280 1 9.22722 17.0589 12.2393 19.2623 -14.5641 0.108859 +281 2 9.27149 16.2912 11.647 -4.87121 6.1965 2.03703 +282 2 10.0709 17.0037 12.729 -13.5572 10.6592 -2.64279 +283 1 13.3059 12.9585 7.95053 -5.93488 5.61094 -2.56551 +284 2 13.3162 12.2379 8.59837 1.79032 5.44422 0.740585 +285 2 13.8923 13.6822 8.21069 6.53108 -7.176 5.15054 +286 1 14.9676 2.9565 15.3436 -0.386658 0.574387 3.68052 +287 2 14.4202 2.18777 15.1252 1.77471 7.19316 -4.43588 +288 2 15.6633 3.03092 14.6718 -7.27619 -4.52831 0.823712 +289 1 9.86266 15.5244 17.0043 3.51131 -4.56125 -2.22878 +290 2 10.4016 14.759 16.7592 -3.4195 -0.793849 -1.98877 +291 2 9.23782 15.2217 17.674 1.65588 4.18023 5.21634 +292 1 11.2982 8.26605 16.5436 5.00814 15.3472 3.18516 +293 2 10.6561 7.79454 16.0057 0.999826 -4.04983 -0.0472571 +294 2 11.6606 7.65108 17.1873 -4.09078 -4.29715 -0.00155616 +295 1 3.81225 18.1964 16.7292 10.4788 2.16731 8.30533 +296 2 4.28955 17.5863 17.3008 -0.586781 -10.0924 -3.62086 +297 2 3.8829 0.368785 17.226 -6.17555 6.78007 -4.03101 +298 1 2.19803 4.12169 8.95254 -8.42555 5.0907 -8.8117 +299 2 3.07539 3.82533 8.67919 -2.6088 -0.1453 11.8715 +300 2 2.06404 4.00225 9.90658 13.5851 0.597917 -5.47855 +301 1 9.88178 10.3569 9.73038 4.79618 9.75255 -1.56513 +302 2 9.58096 11.2105 9.34815 0.270313 -13.7408 11.2463 +303 2 10.0884 10.4563 10.6769 -5.68787 3.60286 -6.41077 +304 1 9.72212 0.809424 10.8539 19.6856 13.2875 8.50656 +305 2 9.35568 18.6419 11.2241 -8.56647 -0.801274 -6.22283 +306 2 9.1718 1.19131 10.1642 -10.1616 -7.34852 -1.36201 +307 1 9.20808 15.1775 10.2123 -15.4381 -3.13199 6.73164 +308 2 8.85567 15.9769 9.80113 1.42232 -2.21967 -3.83769 +309 2 8.41617 14.6283 10.3808 11.8702 3.92611 -8.2586 +310 1 0.995689 9.3369 10.3259 -16.0333 -0.722577 -1.64132 +311 2 1.04111 10.3025 10.3672 11.5337 -2.90556 1.12718 +312 2 1.85551 8.94205 10.1494 2.50931 13.4523 1.23502 +313 1 16.8622 4.87275 8.19393 -0.422934 0.254968 7.2846 +314 2 16.1689 5.44633 8.57547 10.3862 -6.79292 -0.962882 +315 2 17.2033 4.29721 8.90095 -5.62498 7.92604 -8.45296 +316 1 14.656 14.7011 0.368319 0.981504 1.6367 -2.03469 +317 2 15.1464 15.0731 1.12238 -4.61865 -0.709772 -8.09446 +318 2 13.8079 14.3976 0.718239 6.88081 -1.79732 0.157513 +319 1 3.54139 11.054 9.61635 4.40574 2.25524 -6.23941 +320 2 3.65641 11.5568 10.4349 -3.33961 -4.79202 -0.629126 +321 2 3.06202 11.6341 9.00365 5.95536 0.511998 4.3162 +322 1 11.0657 10.8474 1.29636 2.92174 -3.12366 4.90686 +323 2 11.2982 11.6263 0.767958 -3.5102 -3.65436 5.75862 +324 2 10.1232 10.6698 1.15822 5.54645 2.63321 -1.67034 +325 1 13.2072 7.07995 12.8701 -0.715054 4.17079 -6.48984 +326 2 14.1512 6.89692 12.9697 -2.29399 1.70307 -2.36257 +327 2 12.7789 6.22148 12.7926 -0.519741 -2.64677 3.01569 +328 1 9.62848 1.89714 0.960589 0.144249 -1.27383 8.14422 +329 2 8.75389 1.7191 0.595255 2.62606 0.878667 -4.42234 +330 2 10.2646 1.96201 0.242782 -4.84565 1.17493 -5.89222 +331 1 10.5889 13.5223 4.7138 2.80012 2.67941 -15.7349 +332 2 11.4734 13.1444 4.59356 -4.0194 -1.02806 11.2737 +333 2 10.6142 14.0248 5.53615 3.92037 -3.05166 -0.671 +334 1 14.2891 1.71547 10.914 14.736 9.54636 -9.28817 +335 2 15.0906 1.40219 10.4788 -2.27816 -10.6125 3.67971 +336 2 14.438 2.66833 10.8812 -8.3278 1.7804 6.62982 +337 1 14.6539 12.3888 11.7057 -9.85382 -5.79197 9.84531 +338 2 15.5174 12.4906 11.2689 -13.4179 -5.72309 -9.10321 +339 2 13.9464 12.0325 11.1297 19.1264 4.07718 -1.67851 +340 1 8.24463 5.07042 9.80489 8.67652 16.3821 0.210642 +341 2 7.41075 5.25266 10.2586 0.116202 -10.888 -2.54867 +342 2 8.19641 4.23298 9.33202 -10.3006 -5.74151 5.58561 +343 1 1.57762 16.8331 18.335 1.68687 -2.26048 -0.033424 +344 2 1.80587 17.1847 17.4697 -0.252498 3.71983 1.68741 +345 2 2.01633 15.9753 18.3429 -7.29056 -3.61139 0.997127 +346 1 1.4432 17.2346 15.332 2.65894 -7.35401 -5.7102 +347 2 1.56202 18.0921 15.7447 -7.04866 6.37518 1.22888 +348 2 0.495246 17.0477 15.225 10.7628 4.03376 7.259 +349 1 3.71499 5.60328 6.17396 -2.46237 18.0728 1.59518 +350 2 3.14409 6.20568 6.67532 2.19379 -7.75625 0.984178 +351 2 4.32024 6.21155 5.72591 -1.08806 -7.05296 -5.84211 +352 1 12.3532 9.43776 14.1893 13.0079 -11.8089 -5.25996 +353 2 12.7562 8.63341 13.7793 -8.52026 15.4152 14.9752 +354 2 12.1872 9.21442 15.1219 0.0848175 -4.0166 -10.4276 +355 1 4.03165 15.279 6.91423 11.4052 5.55751 -7.84178 +356 2 3.54353 15.996 6.48767 -3.99323 -1.71496 7.04649 +357 2 4.96733 15.4866 6.74143 -6.91754 -4.3684 4.91577 +358 1 0.598678 8.56195 14.8837 5.20406 11.6905 0.774862 +359 2 0.593362 9.51845 15.0326 -4.59172 -3.85379 3.33684 +360 2 1.20863 8.47913 14.1435 0.530109 -4.80423 2.60663 +361 1 12.9822 8.33824 10.332 -12.7812 8.13505 -15.7365 +362 2 13.7449 7.91273 9.91994 1.65618 -4.07378 8.99333 +363 2 12.9305 8.07685 11.2552 9.52621 -6.7264 2.9301 +364 1 15.3077 7.66451 3.49902 -16.235 -26.2008 20.478 +365 2 14.5457 7.14577 3.24297 -4.72624 11.0142 -23.2354 +366 2 15.4625 7.21195 4.33822 21.3334 18.0327 3.91528 +367 1 17.3129 6.65992 0.0418436 1.52354 1.06354 -1.27952 +368 2 16.9014 5.84978 0.373955 -3.48337 6.90323 -1.87832 +369 2 16.58 7.23266 18.3971 4.62858 -6.17573 2.16922 +370 1 8.83009 6.92284 7.82744 0.252992 -5.92817 5.57761 +371 2 9.76137 7.15634 7.81451 4.22584 7.3373 -3.58966 +372 2 8.73794 6.33872 8.59756 -2.97854 -0.622916 -4.66555 +373 1 12.3396 0.625886 1.18148 -8.16379 -0.652746 9.01197 +374 2 13.1345 0.755236 1.71568 4.24005 -1.61972 -8.33969 +375 2 12.5055 18.5332 0.58867 3.80642 2.13695 -0.293066 +376 1 5.66619 15.1148 14.5143 -6.5884 11.0519 3.391 +377 2 4.74474 15.2404 14.7783 -0.0534379 -6.99417 -3.01637 +378 2 5.9729 15.9975 14.2655 4.1321 -4.56061 -2.72375 +379 1 3.84883 6.51764 1.70764 -0.24517 -12.2729 -5.84301 +380 2 3.34882 7.24325 1.31145 3.38543 6.95106 5.25371 +381 2 3.97654 6.73657 2.63696 -3.88246 4.168 -0.0932901 +382 1 3.88114 11.6142 12.2659 5.57001 4.81087 6.19714 +383 2 4.75444 11.9544 12.4977 1.45427 -2.38077 -3.49117 +384 2 3.27884 12.2304 12.6965 -5.21243 -4.02352 0.863052 +385 1 5.43603 3.86764 15.8623 7.54926 19.6814 5.52869 +386 2 6.13377 3.21124 15.7334 -3.30504 1.34649 -4.68995 +387 2 5.89589 4.73554 15.9355 -10.2176 -19.0214 -2.32011 +388 1 14.4546 10.3201 4.4055 -4.6195 -17.8145 -6.66778 +389 2 14.5894 9.8066 5.2203 1.29615 2.58376 -6.73886 +390 2 14.6351 9.71867 3.64602 0.226975 12.0799 18.4878 +391 1 7.91148 17.3357 9.20787 -1.7112 -7.64626 2.59046 +392 2 7.14677 17.4921 9.78359 1.89149 7.49144 -9.53339 +393 2 7.98506 17.9868 8.49476 -7.16328 0.988414 5.46347 +394 1 4.5072 14.4394 3.95775 1.71054 11.4257 7.67338 +395 2 4.60793 15.3916 4.19235 0.708777 -20.878 -0.615863 +396 2 4.75094 13.8726 4.71695 -2.09911 13.0171 -9.33913 +397 1 14.3103 7.38832 15.7657 0.217846 1.64546 9.18842 +398 2 15.2433 7.23588 15.5844 -0.0812074 1.42566 -0.574095 +399 2 14.3036 7.75428 16.6621 0.0607731 -0.988243 -5.21848 +400 1 2.8988 18.2304 1.89629 8.58281 11.0644 9.98123 +401 2 2.46496 17.5082 1.44481 -2.59003 -3.64619 -8.76243 +402 2 2.19471 18.7603 2.28641 0.940953 -0.0494932 1.95923 +403 1 7.97286 1.6093 4.54004 -3.7555 -8.8471 12.6183 +404 2 7.33734 2.04506 3.96057 8.79876 5.02214 -6.32296 +405 2 8.86006 1.965 4.43164 -2.78989 3.02833 -7.03085 +406 1 2.61876 14.1356 17.7492 -10.3822 -13.3904 -3.64852 +407 2 1.93119 13.4601 17.9363 9.46205 16.209 2.13837 +408 2 3.45643 13.7285 18.0162 -4.37303 1.24885 0.341178 +409 1 0.743255 1.70456 13.8731 3.59522 3.89384 -8.23695 +410 2 0.90651 1.38191 14.7629 -6.62821 1.47751 3.8543 +411 2 18.4338 1.82907 13.7582 5.96409 -0.15878 4.57237 +412 1 4.54424 18.6047 13.95 -3.57477 5.05027 -2.13798 +413 2 5.48468 18.3837 13.9843 -5.3566 -3.00882 -0.547935 +414 2 4.15141 18.3634 14.8001 4.77528 1.99072 0.545271 +415 1 7.0969 0.526127 18.3635 1.96349 3.45814 -4.17057 +416 2 7.27221 0.201121 17.4702 1.10961 -1.44826 4.33327 +417 2 6.13787 0.588122 18.4485 3.2238 7.1666 2.24 +418 1 16.0917 18.4266 14.1084 2.59329 0.57669 -10.3481 +419 2 15.3502 17.9157 13.7545 1.31994 6.64432 9.22997 +420 2 15.9271 18.7357 15.0116 -3.89333 -11.6647 -1.43214 +421 1 10.0733 4.52495 16.275 12.9842 -2.30982 2.85456 +422 2 11.0043 4.70153 16.4703 -2.64404 5.32532 -3.085 +423 2 10.0864 3.57376 16.1251 -6.72333 -0.470122 -1.54666 +424 1 15.8636 17.8904 4.42819 -6.03116 8.53171 5.31621 +425 2 16.3871 18.7073 4.48664 -0.23776 -8.88425 -2.03055 +426 2 14.9745 18.1441 4.72479 9.46919 -4.85854 1.60726 +427 1 6.9475 17.372 13.7315 15.8768 1.84738 17.2901 +428 2 7.36738 17.5483 14.6019 -4.78498 1.02898 -17.1267 +429 2 7.68915 17.2477 13.1142 -8.54431 1.43966 5.77183 +430 1 13.2923 6.53747 6.71701 -11.5961 -7.93952 14.6915 +431 2 14.1983 6.84596 6.64723 3.17712 4.25021 -11.0614 +432 2 12.8934 6.43009 5.84838 7.58936 1.28323 -8.80485 +433 1 7.69653 2.37351 9.2065 12.517 1.33593 -3.6252 +434 2 7.21057 2.29 10.0355 -5.39375 -0.506169 -1.44147 +435 2 7.12159 2.1318 8.46594 -3.32624 -2.43573 8.05936 +436 1 15.157 14.8759 13.6545 4.5209 -3.06988 2.24561 +437 2 15.0369 15.0852 14.5928 -3.37623 1.75424 -5.30162 +438 2 14.3708 15.1144 13.1546 1.18854 2.2818 3.55032 +439 1 9.31032 8.32311 3.71462 16.317 -0.492826 6.27183 +440 2 10.1522 8.77498 3.89843 -7.06732 -0.949504 -0.86517 +441 2 9.4815 7.39306 3.91425 -6.58464 2.05554 -3.01208 +442 1 17.7054 13.4931 16.4528 -2.79698 17.5255 -9.98682 +443 2 16.7518 13.3863 16.3682 2.15912 -8.30505 3.41837 +444 2 17.8443 14.3312 15.9805 5.97419 -5.13367 5.17943 +445 1 5.02162 10.6562 2.64136 -2.02283 -9.27068 2.47877 +446 2 5.69056 10.1772 3.15718 -2.95942 7.94984 0.663407 +447 2 4.59516 11.2797 3.2389 2.78246 -2.35968 2.10645 +448 1 3.7261 8.35111 10.2906 -2.0647 -5.12326 -12.4171 +449 2 3.87558 9.26669 10.0174 -1.23075 2.88832 6.28188 +450 2 3.61938 8.33938 11.2471 1.47542 3.72119 -0.959794 +451 1 16.077 7.09208 6.26442 0.512876 -15.8531 0.565556 +452 2 16.8498 7.55114 6.61759 -4.58181 2.74438 -1.19615 +453 2 16.2841 6.14901 6.36212 0.103861 8.35624 -6.71996 +454 1 15.1586 7.03156 9.12145 1.35056 8.00181 -20.3615 +455 2 15.9739 7.38238 9.50783 -5.19642 1.69713 -0.962803 +456 2 15.0724 7.48187 8.24992 4.14438 -5.93719 19.2407 +457 1 6.4279 13.1173 12.8809 -5.50985 -11.8139 -9.3985 +458 2 7.12916 12.5687 13.2568 1.68182 7.24531 -2.67671 +459 2 6.29661 13.8986 13.4214 -0.338885 -0.946459 7.65298 +460 1 12.1214 4.48617 13.0834 13.9874 7.50725 -12.3985 +461 2 12.203 4.65044 14.031 -7.85782 -1.77094 2.73271 +462 2 11.2673 4.11709 12.8488 -4.68474 -5.36964 10.3853 +463 1 11.3361 8.19542 7.84742 15.1179 -11.1226 16.1752 +464 2 12.0446 7.62229 7.53485 -1.89389 0.170875 -13.8157 +465 2 11.6069 8.28902 8.77112 -9.48953 8.11742 -0.143346 +466 1 17.184 10.7876 7.43369 13.5323 -0.921102 -17.174 +467 2 17.9233 10.1981 7.20811 -10.1233 -1.22821 11.3165 +468 2 17.1161 11.3267 6.63249 -5.49276 7.55364 9.36769 +469 1 5.23991 18.1348 11.0582 -10.3762 -3.21686 -5.77572 +470 2 4.63631 17.985 11.8048 7.12888 1.45886 -5.61107 +471 2 4.69408 18.0516 10.2533 5.93648 2.65605 9.16476 +472 1 7.56507 17.5919 1.8299 2.38736 9.59194 1.23507 +473 2 7.95273 16.7967 1.45285 -6.05148 -1.8022 -9.76241 +474 2 7.59068 18.2848 1.14776 -2.89899 -11.2976 1.8216 +475 1 1.88529 12.921 13.6059 -1.54804 -3.98178 5.6231 +476 2 1.43748 12.3178 14.2147 5.26513 0.934067 -3.79148 +477 2 2.14524 13.6768 14.146 -0.717118 1.88599 -5.70238 +478 1 9.71545 6.78651 14.8047 -15.2171 15.1422 7.50698 +479 2 9.90531 5.90708 15.1331 4.86835 -12.5985 -3.10865 +480 2 10.0627 6.91606 13.92 3.16992 -4.80507 -4.41639 +481 1 15.2317 4.3547 10.7806 -19.2619 -13.8042 -17.3299 +482 2 16.1692 4.17769 10.7161 9.63774 3.67614 12.8518 +483 2 15.0389 5.06132 11.3962 11.3469 5.0749 6.12787 +484 1 11.2086 6.13697 0.180528 -13.4008 -14.4307 -10.9666 +485 2 11.2654 5.18187 0.0337896 12.1183 5.06406 4.26486 +486 2 10.2799 6.29806 18.6081 2.85376 11.1709 5.84358 +487 1 0.155975 11.3317 15.1259 -12.2739 12.4049 -22.3111 +488 2 18.2869 11.6878 14.3448 9.29886 -6.35489 23.8975 +489 2 18.7388 12.0248 15.8046 -8.78344 -4.02614 -5.34871 +490 1 7.07225 9.17108 7.27057 -4.95781 3.28344 -6.42365 +491 2 6.44778 8.45946 7.46529 5.34767 -0.253084 5.87629 +492 2 7.94637 8.76128 7.25029 -3.14507 0.531691 2.27088 +493 1 18.4147 15.4309 12.3592 -5.86353 -0.606553 -5.09086 +494 2 0.72281 15.5186 12.2612 4.29187 -2.85716 2.67478 +495 2 18.0791 15.7216 11.5043 -3.32345 0.421348 1.66841 +496 1 16.5543 4.36503 5.23509 20.0373 -2.39618 26.5758 +497 2 16.7455 4.21973 6.1845 -16.121 -2.23612 -11.2684 +498 2 17.4558 4.42117 4.89188 -6.1573 5.26009 -14.9538 +499 1 17.766 3.07261 10.7271 -5.62269 10.8805 -1.85707 +500 2 0.0408353 3.2985 10.945 -3.12308 -7.03453 -2.35326 +501 2 17.719 2.23067 10.252 6.41295 1.44898 4.1666 +502 1 12.3026 0.0397215 10.1517 -5.9029 17.7484 6.25384 +503 2 11.458 0.404705 10.4688 2.82225 -9.87605 -6.68676 +504 2 12.8944 0.808865 10.1781 1.22751 -9.09827 -0.112681 +505 1 10.357 9.81077 12.3435 10.1956 0.0137966 -0.104503 +506 2 11.132 9.85287 12.9219 -4.83247 1.57396 1.64677 +507 2 10.2731 8.87192 12.148 -4.78867 -1.2901 1.32484 +508 1 0.505846 2.83821 7.01562 3.91094 -2.13436 13.3247 +509 2 0.681162 3.5182 7.67504 1.89272 4.99945 -7.1411 +510 2 0.694039 2.0503 7.53478 0.801338 -5.04329 -7.26695 +511 1 0.437103 15.2686 6.90942 10.3075 -26.8847 6.28938 +512 2 0.575652 15.2733 7.87231 -4.50905 3.86257 -7.07916 +513 2 0.764375 14.3681 6.66626 -11.1886 22.2654 -1.84191 +514 1 16.9895 7.01682 15.3107 -21.8777 2.45652 -5.46979 +515 2 17.7216 7.6089 15.1142 9.4824 -7.00642 -0.959024 +516 2 17.2645 6.09907 15.4073 14.9833 2.67634 2.96399 +517 1 9.01274 12.4171 8.12853 10.6441 15.1284 15.6095 +518 2 9.41612 11.8292 7.47716 -12.8498 -4.61215 -9.56742 +519 2 8.05003 12.5053 8.0704 6.97129 -9.84551 -10.1137 +520 1 1.26391 1.92336 3.04659 2.32337 -11.3487 -0.982019 +521 2 0.972058 2.42084 2.27545 2.43588 3.35199 3.68236 +522 2 1.90572 2.43981 3.5544 -5.46738 3.49891 -6.33947 +523 1 4.13143 15.1122 9.67174 -10.3949 2.47722 13.8895 +524 2 4.06276 15.2642 8.72313 5.39511 -1.60046 -0.0768584 +525 2 4.99495 14.7433 9.87874 3.88633 -1.07729 -6.21534 +526 1 7.19145 2.18155 14.5787 4.86443 0.520714 0.489557 +527 2 6.89453 1.81445 13.7426 1.87671 -5.23084 1.53267 +528 2 7.73681 2.92919 14.317 0.289792 2.5421 2.67041 +529 1 18.6 14.6947 2.16091 -2.26171 3.41683 0.482467 +530 2 0.820032 15.117 2.19003 5.03273 -5.31768 -1.38278 +531 2 17.9827 15.4314 2.17519 -7.65677 -2.44766 2.74205 +532 1 9.95161 2.77613 12.9401 9.45852 -1.28953 0.462065 +533 2 9.84872 2.18467 12.1812 -5.82301 1.90383 1.05008 +534 2 9.27924 3.46642 12.8986 -6.28602 -3.28272 -2.83121 +535 1 2.83159 8.92314 13.0298 -5.32883 -6.03653 -2.71455 +536 2 3.23927 9.77312 12.842 3.02047 6.8466 -0.359778 +537 2 3.51958 8.34046 13.3637 5.40811 -1.61307 4.23789 +538 1 3.22435 8.37789 3.65229 -1.03338 2.31116 19.4552 +539 2 3.68753 9.01983 3.09696 -0.346577 4.63804 7.35474 +540 2 3.38788 8.57936 4.60408 0.951973 1.27409 -22.7571 +541 1 5.6137 7.19416 8.52025 7.21613 5.80474 -6.44533 +542 2 5.78863 6.24316 8.52523 -9.99458 0.454093 3.85202 +543 2 5.0179 7.43184 9.24037 0.527922 -7.72891 3.36669 +544 1 14.8805 1.29251 2.00129 6.0675 21.6566 -5.88084 +545 2 14.8065 2.10545 2.50153 -6.7285 -1.94379 16.9269 +546 2 15.1655 1.66296 1.16284 -0.437229 -14.9075 -12.229 +547 1 8.26451 15.1933 0.836486 3.22704 -2.0235 12.9462 +548 2 8.92324 15.2163 1.54184 12.9519 -3.35665 -8.03315 +549 2 7.55879 14.6837 1.25205 -6.95241 0.364363 -7.46808 +550 1 15.625 1.34415 7.23495 -17.3283 -0.11068 -5.87671 +551 2 14.9596 0.769214 6.81661 10.6011 2.38946 3.65492 +552 2 15.1493 2.17629 7.38417 4.13791 -2.68619 2.35471 +553 1 4.93041 13.0764 18.5264 9.84655 1.48115 -2.02825 +554 2 5.35318 13.1968 0.744685 -3.49153 -1.64799 -2.34468 +555 2 5.56664 13.4414 17.8965 -2.33559 -1.35641 1.38511 +556 1 15.3557 8.48379 18.1448 0.204246 14.4785 -5.82183 +557 2 15.7265 9.09289 17.4831 -0.830936 -8.68367 1.885 +558 2 15.168 9.07051 0.245745 1.7123 -4.50429 2.39894 +559 1 12.0892 3.02993 18.3645 -15.9576 34.4498 -4.49703 +560 2 11.9769 2.60431 0.571005 13.6468 -16.1673 -1.05926 +561 2 12.5269 2.48004 17.7153 4.47893 -15.6345 5.41851 +562 1 13.2117 12.674 5.1931 -10.339 11.1011 -13.5125 +563 2 13.668 11.9204 4.80624 6.1285 -2.92776 7.79567 +564 2 13.4681 12.7869 6.11335 2.67539 -7.97004 0.458585 +565 1 6.0506 7.06933 0.0406962 1.31452 -3.72946 4.6718 +566 2 6.04306 7.98784 18.9476 0.374235 14.6189 -4.65006 +567 2 5.24553 6.71887 0.435288 -0.866845 -3.58603 0.782556 +568 1 17.739 15.9899 15.0125 -12.5206 6.16285 -12.4036 +569 2 16.945 16.5161 15.03 -7.46495 5.1976 21.0221 +570 2 17.8264 15.955 14.0627 17.7161 -15.0875 -11.5838 +571 1 13.1794 1.00208 16.5735 3.37979 -5.34722 -6.70143 +572 2 14.139 0.860857 16.6169 -5.21536 -1.33728 6.50102 +573 2 12.8035 0.137283 16.3512 2.48828 2.22182 6.02943 +574 1 11.096 14.5828 7.22348 0.0189977 4.74793 7.83345 +575 2 10.4045 14.1614 7.73717 -8.54387 -1.14011 0.371667 +576 2 11.8979 14.1335 7.50232 3.58446 -6.30574 -4.63725 +577 1 17.5104 8.62105 2.08846 14.2737 4.97696 2.51664 +578 2 16.6904 8.42754 2.54903 -5.27316 -4.4343 -3.04137 +579 2 17.6167 7.98338 1.37729 -7.36397 -7.55614 -1.26172 +580 1 12.3515 7.96855 1.99107 6.37927 0.258975 7.77687 +581 2 12.1159 8.90068 1.90258 -3.43959 -5.51169 -5.98444 +582 2 11.9581 7.4701 1.26507 -2.67829 1.90847 0.988543 +583 1 11.8954 14.6159 10.3514 1.85125 4.19108 3.73581 +584 2 12.1615 13.856 9.81631 -7.50724 5.70574 2.33101 +585 2 10.9524 14.815 10.2079 9.27078 -9.38408 -0.682121 +586 1 6.88225 7.03081 15.6002 -4.063 -7.66118 -6.77733 +587 2 7.75096 7.17076 15.1857 -5.63662 2.89282 10.0227 +588 2 6.77779 7.6167 16.36 6.70206 0.515961 -5.66863 +589 1 8.00078 4.70171 13.472 -1.59283 -4.83357 -4.64481 +590 2 7.27623 4.81783 12.8396 5.32657 -1.99722 0.885811 +591 2 8.48998 5.527 13.4768 -0.383179 2.4117 0.469228 +592 1 13.3975 12.1709 14.2706 1.21587 3.44049 5.53322 +593 2 13.2724 11.2098 14.2197 -1.68144 4.93388 -3.39254 +594 2 13.8611 12.4606 13.4725 -0.646036 -5.76058 -0.123004 +595 1 14.8166 9.4384 7.29692 -7.31149 -4.84482 -6.71483 +596 2 15.6063 9.98387 7.39943 -3.2576 1.32409 4.65546 +597 2 14.0612 9.86586 7.70853 4.31514 4.68737 1.52589 +598 1 12.6657 17.0265 3.08863 -0.499632 18.4226 10.5493 +599 2 13.0409 17.4141 3.89779 -4.03665 -9.69042 -5.1428 +600 2 12.0457 17.7132 2.78031 5.51866 -13.6109 -0.0343421 +601 1 1.16791 7.14337 17.4519 -17.3777 -0.471365 -9.17207 +602 2 0.285968 6.88879 17.7816 4.71885 8.57951 0.206219 +603 2 0.996987 7.64547 16.6337 5.09703 -7.79381 5.85561 +604 1 12.7928 5.13809 15.6672 21.9233 -6.79759 1.12632 +605 2 13.5314 4.49934 15.6812 -12.3388 3.06691 0.377185 +606 2 13.2535 5.99313 15.6546 -7.1176 -2.71451 -0.771614 +607 1 2.50804 3.40102 5.01245 -9.19737 1.42964 37.6951 +608 2 1.85734 3.08405 5.69632 14.2768 7.06331 -19.9109 +609 2 3.04485 4.07021 5.49582 -10.9118 -9.07044 -17.2872 +610 1 8.33238 11.2579 13.4651 -31.1482 13.4197 6.60268 +611 2 8.24927 11.0816 14.4232 19.8118 -8.42601 -14.5581 +612 2 9.11403 10.9307 13.0113 5.91799 -11.9552 15.0186 +613 1 12.8978 1.37199 13.3367 -3.68795 11.8567 -21.2004 +614 2 13.3586 1.33808 12.4821 5.12584 -5.42725 10.3839 +615 2 12.3812 2.18266 13.2296 0.582289 -3.8456 10.447 +616 1 6.35916 13.6786 2.13932 11.022 -2.36774 12.7417 +617 2 5.81416 14.065 2.83164 -5.92624 2.48265 -4.44044 +618 2 6.97105 13.1303 2.64934 1.90703 -2.61302 -7.4669 +619 1 15.9256 6.59608 12.7788 -4.50753 -7.00075 -5.11208 +620 2 16.441 7.14613 12.1828 -0.0403293 3.27533 -1.15613 +621 2 16.337 6.66123 13.6439 3.64448 2.92523 3.21919 +622 1 16.8436 0.710185 9.59384 -10.8386 -3.59173 0.641976 +623 2 16.678 18.424 9.8391 7.1202 6.86076 -6.23598 +624 2 16.34 0.863872 8.77611 6.63769 -2.37412 0.960785 +625 1 6.14874 11.7365 8.37914 -9.33508 -33.9533 -7.34454 +626 2 5.23473 11.5355 8.67103 13.3879 7.28881 -1.35634 +627 2 6.50048 10.8558 8.08418 -3.72877 24.3898 8.07481 +628 1 2.86629 8.64627 0.414665 29.1459 -9.93647 1.24251 +629 2 2.37091 8.1673 18.3782 -14.09 11.8062 8.4924 +630 2 2.39345 9.32329 0.907466 -18.2396 -1.77699 -9.50941 +631 1 10.1496 10.4602 6.51654 2.68196 -4.3054 1.18084 +632 2 10.6351 9.79475 7.02051 -3.21697 0.687034 0.899044 +633 2 10.5797 10.4719 5.65285 -1.94715 4.18574 1.72512 +634 1 6.74842 15.6916 6.55665 -2.66838 16.8954 6.36263 +635 2 7.13132 16.1354 7.32023 -0.325366 -7.45035 4.57015 +636 2 6.8063 16.3799 5.88394 5.31174 -8.689 -7.83261 +637 1 6.45137 13.1469 5.60457 -4.49761 -5.86725 0.527716 +638 2 6.60666 13.9979 6.03098 2.95924 -2.27328 1.19215 +639 2 5.97977 12.5923 6.23705 2.74812 2.58161 1.74453 +640 1 16.8067 12.5538 9.81832 0.32671 -4.80998 5.18546 +641 2 16.9975 11.894 9.13199 -1.38663 9.72579 -2.40586 +642 2 16.8023 13.4365 9.43343 1.83869 -5.34542 -5.01893 +643 1 6.05747 2.94525 2.83457 1.69886 0.640591 -2.15275 +644 2 6.28227 3.83854 2.57267 5.15417 9.09864 3.82618 +645 2 5.67557 2.57416 2.03485 -2.61266 -9.3622 -0.552159 +646 1 10.8942 3.30264 3.28891 6.21412 -5.01644 3.41466 +647 2 10.2824 3.98758 3.58006 -2.01501 -0.119341 -5.67488 +648 2 10.543 2.90591 2.48434 -5.60317 1.35459 0.297545 +ITEM: TIMESTEP +30 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.7097 7.05343 17.9609 20.7509 -2.32452 -4.15205 +2 2 7.78893 6.94819 18.1674 -15.0431 -3.26874 3.90688 +3 2 8.91258 6.41114 17.2706 -4.14568 0.140094 0.745653 +4 1 18.6207 8.28878 6.84456 -10.9758 14.7568 -16.4597 +5 2 0.033254 8.12327 5.87995 7.78297 -6.3031 11.7942 +6 2 0.390602 7.58629 7.343 9.14113 -10.4614 1.3502 +7 1 8.4202 18.5906 6.81681 -12.3331 6.77681 2.70587 +8 2 9.32414 0.194792 6.65918 12.4366 2.53215 -2.1327 +9 2 7.89923 0.683074 6.46691 2.1768 -2.64942 -1.08929 +10 1 6.58134 1.82408 11.6823 -18.6778 6.99539 14.5251 +11 2 5.88329 2.28495 12.2086 12.5233 -11.9933 -14.8966 +12 2 6.20729 0.949756 11.4934 -0.484037 1.974 1.03676 +13 1 7.10261 5.71907 2.36398 18.2567 -30.46 4.77574 +14 2 6.748 6.26194 3.05915 -16.1408 13.0855 0.817955 +15 2 6.89353 6.07497 1.50557 -7.56713 14.4666 -6.71064 +16 1 16.2146 10.1912 16.1045 25.8326 -16.9059 -6.28167 +17 2 17.1924 10.2614 15.9892 -26.0275 4.96146 3.01812 +18 2 15.8649 11.0425 16.3511 -1.01593 12.6392 3.03555 +19 1 10.6309 14.9782 2.32852 5.54907 12.6484 -4.66534 +20 2 10.5683 14.607 3.21596 0.623447 -1.40903 0.430751 +21 2 11.0949 15.8303 2.43151 -6.58286 -12.6372 2.6945 +22 1 17.1592 8.25618 10.4876 -10.0218 -2.97818 8.46282 +23 2 16.7485 8.99843 10.9576 2.65758 -6.15573 0.24812 +24 2 17.9939 8.575 10.1448 6.84049 6.50961 -0.847785 +25 1 14.8275 15.8902 16.3678 -10.7483 8.55828 -7.5541 +26 2 13.911 16.2262 16.382 8.40977 -5.5752 2.0788 +27 2 14.9328 15.3229 17.136 -2.68587 0.983086 7.72287 +28 1 12.1445 13.398 0.450021 7.16446 -9.51802 2.88894 +29 2 12.0254 13.4023 18.1304 -4.57533 9.09159 6.34311 +30 2 11.5749 14.0284 0.911779 -3.72154 -0.858053 -5.79964 +31 1 9.27791 5.43254 4.03115 12.5872 2.27984 -15.9713 +32 2 8.88042 5.04351 4.80522 -11.7175 -1.93285 8.71688 +33 2 8.63164 5.36398 3.31053 -0.238489 1.95718 4.1093 +34 1 1.81582 4.23406 11.6392 3.52665 -33.0533 9.77708 +35 2 1.78778 5.15359 11.8657 -3.54286 18.5189 3.84305 +36 2 2.12638 3.75505 12.4373 -4.00166 7.6753 -17.1576 +37 1 1.99877 6.82017 8.35649 4.97761 -1.46296 10.7796 +38 2 2.31944 7.23424 9.17304 -0.0326511 4.09138 -10.3959 +39 2 2.07937 5.88268 8.56766 -7.36821 -1.33929 -3.79841 +40 1 5.395 4.41162 7.94446 4.05063 -3.43427 6.53634 +41 2 5.41133 3.44966 7.94196 6.73946 -4.4132 0.768998 +42 2 4.74595 4.62804 7.28165 -7.35272 12.6119 -8.90882 +43 1 3.28409 2.93052 17.527 4.91883 3.31559 -8.51102 +44 2 3.97895 3.44036 17.0791 -2.08356 -9.03714 -1.68785 +45 2 2.70652 3.59221 17.9099 -2.28402 5.9437 7.00724 +46 1 7.47067 5.28165 6.09824 -7.47353 5.76211 -2.63966 +47 2 7.88561 6.05707 6.46631 15.843 7.70036 2.30241 +48 2 6.86027 5.05727 6.79609 -9.98425 -16.5426 3.24835 +49 1 9.77462 7.02047 11.9927 -3.16333 0.34511 -3.92757 +50 2 10.3836 6.39122 11.588 -5.90607 3.51948 -2.51732 +51 2 9.0529 7.19715 11.3548 12.4276 -3.26368 6.69514 +52 1 14.0466 3.57679 8.07144 18.6703 -0.348541 19.5758 +53 2 13.8937 4.22019 7.39343 -5.64007 13.0869 -9.16622 +54 2 14.611 4.0279 8.7381 -15.3074 -10.3909 -10.441 +55 1 4.67183 17.2138 3.98342 -17.1629 -17.7927 10.2823 +56 2 5.57476 17.4036 4.21567 13.953 12.775 -5.74716 +57 2 4.34342 17.7474 3.25626 2.59666 4.69733 -2.98879 +58 1 16.5112 16.6016 10.1232 -22.4077 14.5184 19.5552 +59 2 15.797 16.9077 10.7255 16.9762 -11.2391 -6.18282 +60 2 16.019 16.127 9.45142 2.29692 -6.2585 -6.10264 +61 1 1.96965 4.87893 0.40906 -10.7697 -8.55226 -4.93465 +62 2 2.66061 5.27529 0.941341 5.5274 3.49831 6.88318 +63 2 1.47511 5.62215 18.6951 6.32177 2.44726 -2.78863 +64 1 11.7331 13.3335 16.3023 -6.06186 -8.167 -3.78825 +65 2 11.2597 12.4992 16.3612 -10.498 -1.32756 10.0093 +66 2 12.2577 13.1697 15.5177 8.21427 7.2284 -4.69488 +67 1 10.121 11.0486 16.9167 -7.88764 10.2638 -1.90592 +68 2 10.5124 10.1783 16.9786 2.49636 -9.86729 -0.127492 +69 2 9.16626 10.9164 16.816 6.71354 -1.99355 -1.80005 +70 1 11.7161 17.4964 13.4564 0.653858 7.10726 11.4031 +71 2 12.4343 17.1488 12.9211 3.60089 1.57548 -4.57497 +72 2 11.8646 18.4589 13.5472 2.97554 -11.89 -7.13537 +73 1 6.3779 9.31416 12.2259 -8.95234 15.1635 22.3379 +74 2 6.77463 8.98312 11.4273 14.2971 -1.19702 -8.86117 +75 2 6.96666 9.97806 12.6372 -2.9053 -11.0825 -10.5803 +76 1 16.2282 12.7644 2.6938 13.255 22.6007 -2.42149 +77 2 17.0484 13.1981 2.39924 -4.54016 -10.6437 3.48813 +78 2 15.6471 13.522 2.85837 -6.5992 -7.46489 -1.32569 +79 1 0.640508 12.5852 5.88727 21.753 -1.83143 4.54161 +80 2 0.997304 12.3975 5.01963 2.04371 1.22983 -7.11515 +81 2 18.3646 12.7399 5.72186 -19.0302 3.73655 0.683884 +82 1 5.21387 16.4194 18.454 4.66732 -1.11443 8.72996 +83 2 5.89359 15.806 18.1817 0.824082 -8.56943 -13.0935 +84 2 5.59435 16.7978 0.603858 -5.48698 7.00748 3.62952 +85 1 0.548987 7.64401 4.10842 0.670348 4.32997 2.73018 +86 2 18.6015 7.92625 3.40384 -3.24873 3.72744 -1.92559 +87 2 1.36738 8.12724 3.94642 3.53853 -5.18785 -2.83474 +88 1 3.12734 8.93117 6.50347 30.4123 1.43415 3.20415 +89 2 3.68489 8.55498 7.21169 -11.4249 4.27745 -10.9708 +90 2 2.23185 8.74841 6.74202 -19.2185 -4.73256 7.28786 +91 1 7.31515 10.3274 16.2171 -7.5998 2.86538 3.08356 +92 2 6.58991 10.5191 15.6248 2.07633 0.375924 -7.53004 +93 2 6.86928 10.3012 17.0718 3.58834 -2.41696 5.50844 +94 1 11.1056 1.03439 5.00906 5.66297 2.87297 -9.25474 +95 2 11.3082 1.81468 4.47889 -2.42802 6.95123 8.17266 +96 2 10.7866 0.43271 4.33294 -5.36858 -10.0003 1.63315 +97 1 4.38851 2.75082 13.2055 -1.16421 16.6802 -23.4007 +98 2 4.78143 3.22961 13.9394 0.315345 -9.27332 13.6616 +99 2 4.20912 1.83275 13.4212 4.21877 -6.70893 11.8835 +100 1 8.39225 10.0828 1.81263 -0.204034 19.0364 -5.60934 +101 2 8.35289 10.7959 2.47026 -1.38438 -3.08289 -2.87504 +102 2 8.81547 9.35618 2.25702 3.41266 -13.1645 6.66357 +103 1 10.4926 1.73671 15.571 11.1439 -7.64614 -12.2914 +104 2 11.3949 1.40928 15.4244 -6.59208 6.73213 11.009 +105 2 10.2461 2.06593 14.699 -6.9068 1.71228 -0.826453 +106 1 2.72763 12.9186 7.78215 1.53907 -1.41162 9.17357 +107 2 3.36352 13.5565 7.43734 -3.21302 -0.65885 -4.12251 +108 2 2.22004 12.5809 7.03913 -2.76352 5.50699 -3.09439 +109 1 3.68558 11.672 5.21041 4.08504 4.36046 -3.38247 +110 2 3.45481 10.9554 5.79468 0.598863 -9.40064 6.30918 +111 2 2.92113 11.7973 4.6466 -2.33635 3.52119 -7.07475 +112 1 6.80415 14.4796 16.8864 5.34146 -11.2852 2.95693 +113 2 7.68462 14.091 16.8709 -3.70601 4.15103 0.993665 +114 2 6.49099 14.4407 15.9783 -2.62919 9.78665 -2.68056 +115 1 14.176 14.5561 3.39307 -12.5209 -3.15767 3.59597 +116 2 13.6245 15.3467 3.3085 5.15733 -4.43597 -5.06132 +117 2 13.635 13.92 3.89178 10.6994 6.10439 -0.0738324 +118 1 8.31018 18.1523 16.0453 25.0942 2.73084 1.98444 +119 2 8.89462 17.4796 16.3723 -6.95894 -25.3404 9.38217 +120 2 8.98968 0.119946 15.7574 -11.3153 21.4924 -7.69748 +121 1 4.73581 1.63729 4.92804 -12.581 -10.4736 11.5054 +122 2 3.83953 1.97889 4.8343 1.42607 1.89675 3.67103 +123 2 5.27039 2.18299 4.37483 11.2234 12.2757 -18.577 +124 1 15.0504 12.7475 16.4383 22.4341 -19.9388 -26.396 +125 2 14.708 13.1949 17.1966 -19.6268 9.49299 12.0559 +126 2 14.4413 12.6723 15.6738 0.429593 5.89098 19.3668 +127 1 15.7794 18.4162 16.8297 -23.8108 0.224717 -24.365 +128 2 16.2557 18.6157 17.6209 13.9809 -1.68 17.1984 +129 2 15.4229 17.5182 16.8969 9.44127 2.10519 2.83182 +130 1 1.1656 1.1613 16.5455 9.88565 -3.33075 -8.05438 +131 2 1.89055 1.78579 16.6066 9.02992 -0.102422 -1.61706 +132 2 0.673214 1.35844 17.3295 -13.4515 3.62078 11.8035 +133 1 18.1028 4.54571 15.8941 -4.73113 6.48399 7.96005 +134 2 18.5013 4.04336 15.196 5.27298 -10.1152 -10.2677 +135 2 18.7433 4.58481 16.606 1.22293 0.259147 -1.01212 +136 1 12.236 16.9836 16.146 14.9412 3.5391 -27.9779 +137 2 11.6416 16.3841 16.5672 -17.548 -8.54782 13.2608 +138 2 12.0887 16.8479 15.1863 -0.907912 9.23395 13.7712 +139 1 15.9498 2.53257 18.0253 10.6473 -13.6828 8.83411 +140 2 15.5627 3.24781 18.526 -5.22656 12.7326 -1.10284 +141 2 15.751 2.68965 17.0989 -3.04742 3.76351 -4.61681 +142 1 6.7038 13.8197 10.2271 2.9338 -17.2727 -3.34939 +143 2 6.61667 13.5512 11.144 -2.24755 5.72821 7.93099 +144 2 6.68776 12.9653 9.76874 -1.43812 10.35 -6.56898 +145 1 10.1318 18.2649 2.7724 -13.411 -9.16786 2.85058 +146 2 10.3828 0.244178 2.09267 2.54842 10.4954 -6.81354 +147 2 9.19143 18.056 2.59362 16.7762 1.59207 3.74676 +148 1 2.99108 17.7409 6.10283 23.0954 -1.76337 16.2177 +149 2 2.19234 17.7622 5.58671 -8.31269 -3.84851 -15.8536 +150 2 3.76803 17.7869 5.51609 -16.1123 2.00349 -4.76697 +151 1 12.5756 16.9274 7.99763 -5.18448 9.92793 0.0594024 +152 2 11.7822 16.4009 7.94219 -1.30832 -15.7704 -9.09049 +153 2 12.3073 17.5896 8.63909 10.7698 6.45321 6.22995 +154 1 14.8838 15.2691 8.24901 11.9288 7.15592 -19.4456 +155 2 14.3219 16.0313 8.11935 -17.9047 1.82161 10.6012 +156 2 15.419 15.3185 7.43747 0.964457 -9.38205 7.76842 +157 1 17.6242 18.2515 0.369787 17.475 26.3316 2.73311 +158 2 18.5101 17.9713 0.0958777 -8.0951 -12.2782 0.813683 +159 2 17.7821 0.518901 0.686034 -9.22006 -13.9572 -3.22273 +160 1 0.867554 10.3913 1.38534 13.3292 31.3771 -20.1166 +161 2 0.0708789 9.90853 1.49908 -23.2341 -17.8443 11.3974 +162 2 0.609768 11.125 0.785047 6.92113 -8.95227 10.8017 +163 1 1.63658 12.2225 3.36866 -7.99561 -17.8946 -31.9552 +164 2 1.35203 11.5128 2.74742 7.334 6.03534 21.6261 +165 2 1.63695 12.9742 2.77054 4.15295 9.67724 10.1418 +166 1 0.571199 17.2371 4.87124 -14.5407 6.59112 32.0774 +167 2 -0.059088 17.9662 4.92138 6.12201 4.50556 -13.0577 +168 2 0.445901 16.8548 5.75927 11.2459 -10.7393 -14.745 +169 1 1.10756 0.954018 9.42478 -6.01064 0.927768 -12.2971 +170 2 1.20282 0.614567 10.324 -1.80966 -3.76099 -1.37067 +171 2 0.239583 0.659806 9.09473 9.24115 0.27684 10.6776 +172 1 16.7657 2.33783 13.2856 -4.77092 -12.7415 18.4331 +173 2 16.9235 2.53629 12.3736 4.43968 6.32108 -18.3535 +174 2 16.5017 1.40258 13.3145 0.84997 6.98888 1.09187 +175 1 2.55595 15.84 12.1915 -9.99296 7.89206 -20.2214 +176 2 3.13585 15.4219 12.8083 9.49953 -6.79049 14.4751 +177 2 2.92245 15.6515 11.3148 -0.922807 -1.51117 1.32599 +178 1 16.4223 15.613 5.98575 -3.71667 -18.1819 11.7841 +179 2 17.3247 15.5921 6.33835 -0.216171 6.69275 -4.6749 +180 2 16.2529 16.4332 5.52058 8.23488 6.69239 -4.77655 +181 1 5.80627 5.05529 11.7835 2.20346 1.03406 8.57972 +182 2 5.47099 5.61389 12.5063 0.21977 1.29573 -10.4635 +183 2 5.43215 4.18052 11.9366 -3.48089 3.11082 -1.53573 +184 1 15.1897 4.8564 0.727292 -5.49239 9.65996 -2.72664 +185 2 15.2051 4.71263 1.67299 -4.1535 -7.09946 8.01526 +186 2 14.3467 5.30742 19.2217 7.5675 -5.77492 -4.69919 +187 1 16.3443 16.3423 2.09898 -10.6702 -0.501744 21.7899 +188 2 16.0343 16.7391 2.94116 7.72577 -10.997 -12.8868 +189 2 16.4832 17.1019 1.54751 7.961 8.6491 -12.4493 +190 1 0.271558 4.86315 3.80356 2.16636 -31.8967 4.70784 +191 2 0.500225 5.77685 3.71679 7.2244 19.9811 4.59738 +192 2 1.02077 4.40389 4.23265 -9.838 12.5034 -4.93629 +193 1 2.94659 15.0442 15.0679 0.642608 -6.50925 -4.27186 +194 2 2.75789 14.5701 15.8868 0.637625 5.4096 6.54553 +195 2 2.48063 15.8876 15.1248 -0.665005 -3.22304 2.52721 +196 1 1.13823 14.625 9.55769 -40.6641 2.98648 23.3687 +197 2 1.89308 14.4183 9.03602 24.2615 -17.8348 -5.78778 +198 2 0.899054 13.8694 10.146 16.149 11.9497 -18.7143 +199 1 13.6328 16.6228 11.5317 -8.77554 -4.828 10.6654 +200 2 13.2136 17.4084 11.1616 -1.58446 0.630618 -8.00902 +201 2 13.0391 15.8864 11.302 7.59245 3.60181 -7.14688 +202 1 4.70114 1.47286 0.734685 -3.14847 1.30924 1.42089 +203 2 4.10181 2.05657 0.255283 4.3012 0.912352 -3.9516 +204 2 4.12143 0.893804 1.23429 -1.01367 -7.44934 0.356301 +205 1 1.44259 18.5254 11.8725 4.87725 -20.5249 2.38925 +206 2 1.2982 0.329643 12.7089 -1.92821 4.76162 2.3937 +207 2 1.66413 17.5975 12.0994 -0.659414 17.7173 -3.45023 +208 1 11.5206 10.1171 4.06393 -3.80452 1.00663 -6.51606 +209 2 11.2843 10.553 3.23019 1.0155 -1.19537 2.23558 +210 2 12.4827 10.1039 4.08159 3.36054 1.41703 2.51077 +211 1 8.33991 12.1729 3.71569 5.40649 2.32091 -9.4304 +212 2 9.08268 12.7024 4.00206 12.7546 1.78956 -5.29094 +213 2 7.80528 12.1916 4.49536 -21.4073 -3.06625 11.8611 +214 1 14.3677 4.01314 3.28101 5.46562 4.88363 2.56432 +215 2 15.0857 4.19963 3.89805 0.543674 -3.28085 4.74869 +216 2 13.622 4.5498 3.58084 0.572713 -1.66955 -3.63784 +217 1 5.59145 1.71061 7.51389 3.0333 8.44076 -17.8773 +218 2 4.93757 1.09228 7.83941 -4.88752 -5.30351 6.58254 +219 2 5.37448 1.80426 6.56172 4.34195 -4.37145 14.4788 +220 1 17.8887 1.09435 4.8754 -0.773263 0.600717 5.02725 +221 2 18.623 1.41887 4.35928 5.70444 0.114988 -11.5441 +222 2 17.8389 1.7231 5.59879 -7.43418 -0.321368 4.00301 +223 1 6.81825 9.41317 4.48156 7.11204 -1.13267 15.9283 +224 2 6.84118 9.52277 5.44603 -5.88151 0.934362 -6.29355 +225 2 7.74851 9.26985 4.27279 -2.06614 -3.64671 -7.13223 +226 1 2.66566 14.925 1.97184 3.43761 -5.8072 22.4208 +227 2 3.31024 14.6851 2.65976 -11.6222 2.95672 -3.26291 +228 2 3.19272 14.9753 1.1906 5.92571 0.162325 -19.2981 +229 1 17.2917 12.9099 13.1468 13.6904 -32.8575 1.82925 +230 2 16.4305 13.254 13.3667 -5.78742 18.0954 -2.54799 +231 2 17.8833 13.5932 12.8229 -8.84805 15.1913 2.15275 +232 1 14.9839 10.5629 1.38454 25.7264 11.2091 10.263 +233 2 15.6084 11.2587 1.71974 -19.4135 -18.6888 -7.72567 +234 2 14.1549 11.0026 1.25075 -10.8149 6.915 -1.22185 +235 1 5.70372 6.84607 4.55662 8.80438 8.80025 -0.823305 +236 2 6.10735 7.7373 4.58073 -7.50282 -10.5851 -1.04914 +237 2 6.32636 6.24858 4.99 1.7616 -0.154003 4.43374 +238 1 8.04871 8.29405 10.2754 3.94684 3.34606 -22.4081 +239 2 8.71637 8.94856 10.0317 -1.03323 4.34225 9.84614 +240 2 7.78699 7.97842 9.39774 -4.16124 -6.72066 12.7971 +241 1 13.4913 18.3469 5.77892 -1.26098 13.9384 -13.7404 +242 2 12.815 0.368504 5.57583 1.14564 -3.93427 -2.76608 +243 2 13.0908 17.8361 6.47463 -1.65231 -11.4802 12.6171 +244 1 0.227007 2.59645 0.141675 -14.0496 12.7254 8.33212 +245 2 17.9751 2.93781 18.665 -4.73692 -13.8452 -6.2234 +246 2 0.694599 3.38298 0.431909 14.3746 0.669884 0.426623 +247 1 12.7219 11.0238 9.75183 49.8657 -12.692 14.413 +248 2 11.8223 11.0616 9.49871 -31.5247 -8.5727 -6.88909 +249 2 12.9406 10.0926 10.0008 -12.7634 16.4478 -4.29644 +250 1 0.765495 12.2256 11.092 -6.27201 -3.92882 -21.6672 +251 2 18.4439 12.3344 11.0429 5.26844 -2.50397 8.5312 +252 2 1.08097 12.384 11.9788 -3.27397 5.59862 9.72518 +253 1 5.06534 7.27352 13.4491 9.82463 3.8805 6.07585 +254 2 5.60445 7.97165 13.048 -4.44492 -2.76176 -4.56894 +255 2 5.50693 7.14172 14.2991 -3.01503 -3.24863 -0.495805 +256 1 1.24722 6.90803 11.85 29.2977 26.916 27.8288 +257 2 0.522094 7.24638 11.3513 -16.2758 4.78156 -11.2742 +258 2 1.67283 7.72942 12.2344 -11.891 -29.9717 -16.3043 +259 1 15.4903 9.51892 12.3126 7.40517 -6.095 -16.4028 +260 2 15.1231 10.4002 12.2744 -2.67202 9.46709 6.64342 +261 2 15.3464 9.12903 13.1709 -3.09066 3.82816 8.99587 +262 1 16.6298 12.8631 5.48891 1.11523 -3.92575 5.75418 +263 2 16.4995 13.8048 5.46845 -2.55881 16.2829 11.3267 +264 2 16.4805 12.6501 4.57692 -1.87933 -15.1854 -15.6508 +265 1 6.21094 9.97472 0.0957231 23.6487 -5.34392 2.82943 +266 2 5.60453 10.4038 0.703481 -3.26342 3.61778 2.3496 +267 2 7.09538 10.0231 0.521798 -18.1891 -1.30215 -0.820391 +268 1 12.348 6.08762 4.05307 2.0614 24.7942 -10.4953 +269 2 12.1492 6.85087 3.46448 11.8353 -14.4305 6.54315 +270 2 11.534 5.60454 4.05688 -13.4451 -11.2489 2.03158 +271 1 0.182227 12.8112 0.197519 7.97213 -0.157956 2.72486 +272 2 0.124577 13.5143 0.856815 -1.71897 -0.134619 0.137441 +273 2 18.3975 13.1734 18.0617 -3.09196 -0.84285 -5.0356 +274 1 3.77998 18.5905 8.57799 -18.8802 5.92516 7.26956 +275 2 3.52251 17.9827 7.88131 5.13558 -0.560148 -6.56591 +276 2 2.92387 0.359522 8.79319 10.0752 -0.462424 4.43469 +277 1 7.44275 17.2901 4.46744 -21.5086 -34.4409 7.51913 +278 2 7.83961 18.0981 4.73248 10.1677 27.4444 -0.194329 +279 2 7.33826 17.2675 3.51576 6.23588 9.30645 -6.08156 +280 1 9.24103 17.0711 12.2479 -19.3743 11.7076 -0.715804 +281 2 9.17102 16.3949 11.5719 7.91635 -8.00505 -0.934966 +282 2 10.0835 16.9964 12.6894 10.2718 -1.4174 0.528472 +283 1 13.295 12.9281 7.96455 10.8524 35.2373 8.53109 +284 2 13.4175 12.2933 8.66577 -5.31299 -13.0614 2.94334 +285 2 13.7676 13.7325 8.27776 -0.249345 -13.5851 -11.5496 +286 1 14.9473 2.96516 15.3472 -8.56764 -6.90335 7.41648 +287 2 14.4704 2.13858 15.1989 -5.86972 7.46703 2.11397 +288 2 15.5773 2.99488 14.6333 9.67131 3.29159 -8.66831 +289 1 9.8733 15.5399 16.9999 -1.15808 -3.26391 2.43146 +290 2 10.4067 14.7753 16.7398 -3.17357 -1.97936 0.56939 +291 2 9.29049 15.2638 17.7267 6.50431 4.19029 -1.43758 +292 1 11.3155 8.30103 16.5489 -8.97523 -12.184 6.64215 +293 2 10.5995 7.86385 16.0596 7.08532 7.34183 -0.412451 +294 2 11.4953 7.67267 17.2664 2.19784 9.25982 -2.90547 +295 1 3.86136 18.202 16.7472 -0.00540616 -19.6914 -20.2162 +296 2 4.27115 17.4628 17.2262 -1.12743 11.6131 4.05136 +297 2 3.85436 0.333712 17.2887 2.36829 10.2975 15.3313 +298 1 2.18996 4.14488 8.93819 0.886129 3.08448 -7.12661 +299 2 3.10445 4.02058 8.72725 13.9566 -1.85365 -12.2229 +300 2 2.19804 3.9794 9.87086 -10.6985 1.40109 20.9797 +301 1 9.87077 10.3617 9.71962 10.1113 -1.13074 11.4426 +302 2 9.57245 11.1887 9.34333 -7.01747 6.00246 -6.1834 +303 2 10.1269 10.5679 10.6319 -2.96085 -6.85282 -1.29137 +304 1 9.72151 0.827202 10.8565 -16.8019 0.79505 -1.6906 +305 2 9.17924 18.7332 11.1654 13.4836 -3.87865 6.80866 +306 2 9.14124 1.21724 10.1941 6.30814 7.82285 -3.72399 +307 1 9.21217 15.15 10.2242 6.46373 1.33184 2.55262 +308 2 8.76537 15.794 9.67699 -2.80645 8.81337 -5.09524 +309 2 8.53339 14.5081 10.4276 -6.91387 -6.36492 -2.48134 +310 1 0.979873 9.39617 10.3168 -32.1534 32.2854 2.26584 +311 2 1.01417 10.3672 10.3328 -11.1793 -7.1298 6.70775 +312 2 1.8685 9.20872 10.1515 40.6499 -19.8378 -9.87175 +313 1 16.9127 4.85919 8.18774 -4.59801 12.0977 -12.3954 +314 2 16.2737 5.53573 8.4435 0.928859 1.2732 2.05393 +315 2 16.9639 4.27263 8.93179 4.52425 -11.0836 8.47724 +316 1 14.6737 14.709 0.318185 15.3338 2.15239 -13.9805 +317 2 15.2295 14.9726 1.0606 -1.701 5.56475 -1.20644 +318 2 13.8551 14.4222 0.702232 -12.5496 -7.63291 5.74768 +319 1 3.57822 11.0521 9.58832 7.05767 -0.848593 3.86503 +320 2 3.70772 11.5491 10.4084 -2.82358 -5.49605 1.13538 +321 2 3.0796 11.6369 9.01245 -0.492053 5.16034 -4.32733 +322 1 11.1043 10.8166 1.33994 -11.5702 -13.9866 8.70354 +323 2 11.3928 11.6085 0.903197 7.06397 14.5046 -5.44138 +324 2 10.1649 10.7312 1.10986 7.36828 -2.13735 3.91294 +325 1 13.1846 7.09882 12.8318 18.6724 6.28095 -0.937746 +326 2 14.1536 6.98642 12.9472 -16.4658 1.64828 -3.93553 +327 2 12.8311 6.20921 12.7949 -4.05904 -6.33012 1.01947 +328 1 9.62724 1.89857 0.976269 -5.84048 -4.71512 -19.854 +329 2 8.85605 1.47112 0.556627 5.981 10.7585 7.84687 +330 2 10.1714 2.22507 0.238723 -1.51496 -2.73206 9.47681 +331 1 10.5937 13.5214 4.66199 3.2234 0.0339744 -7.62843 +332 2 11.4486 13.114 4.51461 3.39436 -8.72009 -0.849353 +333 2 10.7191 13.8974 5.52846 -5.55452 9.94363 9.85641 +334 1 14.3279 1.73837 10.9221 -6.80645 -20.6925 1.76137 +335 2 15.1234 1.41881 10.4767 1.97621 6.90305 1.731 +336 2 14.3743 2.69243 10.9875 9.24527 6.91542 -4.56959 +337 1 14.6348 12.3447 11.7069 0.143663 -8.85162 -7.69369 +338 2 15.3924 12.4169 11.1267 15.8185 6.23005 6.53749 +339 2 13.9779 12.0599 11.0796 -19.2308 -4.32411 1.56042 +340 1 8.24345 5.06862 9.81236 -2.43519 -19.796 -15.4196 +341 2 7.42328 5.28077 10.2334 -12.2119 11.2175 13.6651 +342 2 8.03366 4.19231 9.43495 14.0834 8.03075 2.78805 +343 1 1.55958 16.8456 18.3509 0.293915 -24.903 24.1992 +344 2 1.74487 17.2231 17.5072 8.4457 6.47265 -18.7434 +345 2 1.95964 15.9468 18.3277 -12.6492 15.8955 -3.16542 +346 1 1.46885 17.2295 15.3261 -41.9231 18.9429 7.61422 +347 2 1.60163 18.0716 15.7975 2.88525 -7.29411 -7.90761 +348 2 0.471438 17.1304 15.2829 39.2238 -5.53287 -0.382895 +349 1 3.69895 5.65007 6.13962 5.67498 -13.7905 -4.71311 +350 2 3.08621 6.15365 6.67268 -1.79156 10.6243 5.04455 +351 2 4.29662 6.26435 5.6935 -4.62364 1.91275 -0.121461 +352 1 12.3686 9.4572 14.1916 2.50325 4.1373 0.835901 +353 2 12.6534 8.64397 13.7789 7.43403 -8.19142 -7.10693 +354 2 12.2431 9.18714 15.1032 -3.68368 1.41273 6.14038 +355 1 4.03462 15.2828 6.91278 -20.0144 -6.90546 3.84648 +356 2 3.57361 16.022 6.48562 4.0204 -1.30953 4.99773 +357 2 4.97214 15.427 6.85986 17.0804 8.85667 -5.89205 +358 1 0.596937 8.57007 14.913 -2.82207 -2.34568 11.0967 +359 2 0.589839 9.51288 15.1099 0.171131 2.88226 -3.41975 +360 2 1.22453 8.45469 14.2015 6.96836 3.95738 -3.73783 +361 1 12.9772 8.31295 10.3135 -4.52981 3.4147 9.81026 +362 2 13.748 7.88649 9.95158 7.10588 -4.96512 -13.4998 +363 2 13.0418 8.05063 11.2408 -7.87478 3.04011 -0.538852 +364 1 15.3081 7.67138 3.5266 23.4653 37.2808 -10.5735 +365 2 14.5495 7.31548 3.08478 -13.5361 -20.5278 3.76808 +366 2 15.7097 7.21489 4.26906 -13.5998 -13.5183 6.32814 +367 1 17.3139 6.67347 0.0519528 8.75828 -11.5188 0.32751 +368 2 16.922 5.81479 0.236083 -1.36263 0.235584 3.31968 +369 2 16.5542 7.20912 18.4844 -8.7655 12.4237 -8.09845 +370 1 8.86065 6.91878 7.81669 10.1209 17.2302 -14.0365 +371 2 9.80786 7.17641 7.77744 -16.0922 -4.42618 4.57681 +372 2 8.74795 6.24147 8.48473 3.77983 -6.9476 8.96536 +373 1 12.3541 0.627989 1.20673 7.59332 -4.64776 2.86492 +374 2 13.2579 0.528374 1.53727 -3.51801 6.0046 2.76074 +375 2 12.2851 18.632 0.498856 -2.53947 0.382583 -4.14536 +376 1 5.64549 15.138 14.5235 -4.10456 -30.421 5.78959 +377 2 4.73353 15.1769 14.8501 2.72532 6.49481 -6.12593 +378 2 5.9656 16.0086 14.3294 1.76375 18.5631 -6.42604 +379 1 3.85619 6.49135 1.72458 1.34418 -5.76632 6.1851 +380 2 3.4082 7.28863 1.44351 -4.61345 8.91678 -8.73454 +381 2 4.04036 6.67595 2.65567 -1.04596 -4.79787 -3.17499 +382 1 3.88128 11.6181 12.3021 -8.90147 -4.54474 -0.675722 +383 2 4.76839 11.88 12.5585 3.1774 6.51538 0.922611 +384 2 3.25574 12.2257 12.7332 9.80963 -6.2977 -1.14662 +385 1 5.41097 3.86243 15.8619 7.77498 -26.7447 2.47729 +386 2 6.19051 3.2555 15.8125 -22.34 13.8462 -4.82428 +387 2 5.75732 4.74289 15.8731 9.06733 16.771 0.375084 +388 1 14.4275 10.3077 4.42737 -15.4583 -1.2468 24.8449 +389 2 14.4136 9.7945 5.25584 5.65105 6.60384 -6.24763 +390 2 14.7139 9.69599 3.76155 7.16087 -8.52398 -12.4829 +391 1 7.87022 17.3652 9.18307 -6.55512 0.129027 -0.760847 +392 2 7.04604 17.5698 9.62158 -5.94597 -4.85201 9.5143 +393 2 7.92762 18.0395 8.50377 8.60962 -1.46955 -8.60251 +394 1 4.50919 14.4633 3.94747 -3.26277 6.69504 -13.1744 +395 2 4.44326 15.3745 4.23469 1.61374 7.68172 -2.63862 +396 2 4.73121 13.9745 4.72809 3.38773 -13.7326 11.5154 +397 1 14.2916 7.39166 15.7799 -19.0102 -0.643935 -4.97281 +398 2 15.227 7.28492 15.6956 21.3172 -2.59108 -3.06 +399 2 14.1661 7.73476 16.6606 0.966931 5.43289 9.36717 +400 1 2.93597 18.2496 1.90178 2.72474 -19.4407 -7.90163 +401 2 2.41137 17.5137 1.50762 13.3283 19.165 4.04527 +402 2 2.31568 18.912 2.18531 -12.4791 7.28301 8.56329 +403 1 7.97625 1.60842 4.55987 -20.0747 11.2227 -5.58284 +404 2 7.40672 2.18903 4.02942 -3.00667 -10.939 3.58357 +405 2 8.83426 1.86357 4.26417 23.6954 -1.42515 0.234182 +406 1 2.55973 14.139 17.7235 4.4947 4.4122 -3.81652 +407 2 1.9869 13.4419 18.0532 -4.8721 0.171095 2.94118 +408 2 3.45785 13.8729 17.9629 -0.333069 -3.9381 0.822902 +409 1 0.778432 1.72633 13.8806 -27.0748 -1.51039 10.7449 +410 2 0.840363 1.33642 14.7677 3.59517 6.80992 -7.55552 +411 2 18.4512 1.86919 13.7675 25.1129 -0.50251 -4.23703 +412 1 4.5218 18.6217 13.9311 -26.2208 4.76485 6.31935 +413 2 5.44026 18.4597 14.0857 18.6112 -6.32709 -3.49173 +414 2 4.08533 18.4032 14.7706 3.39103 3.57256 -5.13956 +415 1 7.0966 0.590139 18.3583 40.0867 -7.03194 -16.485 +416 2 7.43029 0.218977 17.5038 -14.1267 7.45313 19.238 +417 2 6.15491 0.497007 18.3797 -17.6926 4.43938 -0.268226 +418 1 16.0869 18.4184 14.0665 12.1783 12.0602 19.9903 +419 2 15.2602 18.093 13.7757 -22.8702 -12.1677 -15.3509 +420 2 15.9307 18.6351 14.9998 9.22594 -1.26981 -3.76068 +421 1 10.0615 4.5254 16.2644 17.4965 34.4304 -0.599412 +422 2 10.952 4.96419 16.2693 -15.2122 -21.3498 0.578373 +423 2 10.2001 3.58581 16.3272 5.99955 -12.591 -1.94777 +424 1 15.8874 17.8488 4.44366 26.9944 -8.8935 -8.85545 +425 2 16.3583 18.6921 4.41154 0.375294 -2.3726 2.41747 +426 2 14.9936 18.0388 4.65191 -27.7242 10.9512 11.1951 +427 1 6.97313 17.3837 13.7492 -14.8371 0.980348 6.17816 +428 2 7.33935 17.5289 14.6184 6.46616 5.40365 9.01508 +429 2 7.73032 17.2786 13.1826 8.79779 -2.98362 -9.94394 +430 1 13.295 6.50203 6.69495 9.53809 17.2257 -14.0038 +431 2 14.0496 7.07319 6.46986 -0.499105 -8.31015 13.7378 +432 2 12.8724 6.42857 5.83749 -8.85952 -9.05901 -3.70628 +433 1 7.73318 2.36184 9.23357 -5.82839 -0.191385 25.6357 +434 2 7.13515 2.2598 10.0003 13.8878 3.27143 -3.38814 +435 2 7.19146 2.08044 8.50905 -8.01798 -3.82737 -18.8349 +436 1 15.1683 14.8678 13.6621 4.32457 -5.24538 6.92634 +437 2 15.0117 15.191 14.5524 1.96766 -1.10504 5.54809 +438 2 14.4461 15.1877 13.1369 -6.78809 4.58671 -11.3713 +439 1 9.33811 8.31525 3.72912 -3.71623 14.6513 -1.76526 +440 2 10.1422 8.72537 4.07444 1.32163 -4.04075 -0.39549 +441 2 9.3744 7.3721 3.88081 4.66337 -7.69389 3.46587 +442 1 17.73 13.5264 16.4473 3.62887 -10.5665 6.33517 +443 2 16.8053 13.2497 16.375 1.67263 6.91521 -3.1024 +444 2 17.8249 14.3621 15.9879 -5.28625 7.64018 -4.86126 +445 1 4.99014 10.6392 2.69296 -11.8842 10.0017 7.67541 +446 2 5.62836 10.2105 3.25699 12.1385 -6.17254 3.53336 +447 2 4.64978 11.3543 3.2597 0.304061 -9.29163 -9.90123 +448 1 3.7356 8.34279 10.2382 -0.81373 18.9096 -12.0232 +449 2 3.86658 9.26506 9.94102 0.197912 -10.4595 0.115104 +450 2 3.49052 8.44407 11.1547 0.601112 -5.92985 11.4704 +451 1 16.0428 7.05286 6.2029 -10.6575 13.2953 -5.82849 +452 2 16.855 7.48535 6.46978 4.82485 2.35526 4.73173 +453 2 16.1613 6.12013 6.32007 7.39497 -13.7867 -3.51418 +454 1 15.1327 7.05037 9.11575 3.87713 -5.32828 6.40762 +455 2 15.8626 7.43029 9.61535 2.26476 1.25298 1.00848 +456 2 15.1324 7.53151 8.29313 -1.46271 6.60183 -11.5025 +457 1 6.39444 13.0666 12.8402 5.00849 -18.9174 -4.31708 +458 2 7.14138 12.6166 13.2588 -1.3728 0.0732389 -8.28768 +459 2 6.25233 13.8543 13.3456 -7.70591 16.466 12.3405 +460 1 12.1285 4.48598 13.0882 -38.1563 -9.245 -8.92104 +461 2 12.05 4.67155 14.023 12.2106 4.08095 10.8898 +462 2 11.2367 4.10453 12.8753 29.4794 5.44987 -0.890783 +463 1 11.348 8.18475 7.8598 -17.4059 7.12531 -10.6431 +464 2 12.038 7.63484 7.48501 10.4081 -6.60064 5.31237 +465 2 11.4756 8.28116 8.80352 11.9689 -3.04214 7.26146 +466 1 17.1922 10.8074 7.44155 -25.4203 14.6985 18.6261 +467 2 17.9197 10.2075 7.32737 10.9985 -8.38668 -11.5183 +468 2 17.0629 11.3797 6.67504 9.09121 -1.65978 -2.87918 +469 1 5.25169 18.1248 11.0507 12.0648 3.50666 -3.83562 +470 2 4.62743 17.897 11.7414 -1.9785 0.423337 4.7613 +471 2 4.73712 18.33 10.2687 -7.94827 -3.02158 -5.48025 +472 1 7.57794 17.5568 1.83513 6.93874 5.3114 -35.8297 +473 2 7.86736 16.7596 1.34843 -3.99011 9.3379 11.9664 +474 2 7.57256 18.2518 1.1344 -7.92946 -12.1924 16.8763 +475 1 1.91036 12.9101 13.6013 -3.96045 -14.8375 -19.2024 +476 2 1.39392 12.2568 14.0828 0.939403 1.79227 7.54842 +477 2 2.06766 13.6568 14.1634 3.48639 14.3121 10.7878 +478 1 9.68075 6.78169 14.8149 2.18853 -17.0585 -1.56943 +479 2 9.86519 5.84438 15.0146 -5.66436 10.7434 4.7021 +480 2 10.1054 6.93436 13.9655 -4.91522 4.89205 -3.51643 +481 1 15.2489 4.31705 10.7696 10.3165 19.1063 17.7081 +482 2 16.2033 4.28261 10.8841 1.13215 -16.3849 -6.84609 +483 2 15.045 4.99149 11.4324 -10.9146 -3.35461 -8.40134 +484 1 11.2157 6.13912 0.184288 19.0347 18.6277 4.4365 +485 2 11.389 5.28379 -0.213728 -9.30505 -7.86745 -0.661886 +486 2 10.2971 6.41228 18.7766 -10.0409 -9.92482 -6.17869 +487 1 0.119384 11.3453 15.1007 -14.3711 11.1071 -8.9459 +488 2 18.1083 11.5338 14.3994 8.87914 -3.31428 2.86805 +489 2 18.675 12.1405 15.6491 -0.376992 -6.76779 4.41889 +490 1 7.06293 9.20482 7.26347 16.9728 2.93661 -2.33726 +491 2 6.45996 8.52415 7.5376 -12.746 -11.932 7.1182 +492 2 7.92776 8.76781 7.32981 -4.82181 7.51802 -3.03552 +493 1 18.3776 15.4097 12.3582 -11.3114 -7.16639 4.00893 +494 2 0.682756 15.4096 12.2525 13.0982 4.14044 -6.05458 +495 2 17.9899 15.7976 11.566 2.11158 0.973908 -1.02825 +496 1 16.5513 4.36706 5.24159 -5.09045 5.24791 -23.7034 +497 2 16.6166 4.33687 6.19466 14.1446 -5.59224 10.5876 +498 2 17.404 4.59908 4.81371 -8.86364 -4.80736 14.9956 +499 1 17.7417 3.09647 10.7341 0.291254 -10.6186 -10.4582 +500 2 0.00513181 3.34109 10.9087 8.18655 7.52385 6.55564 +501 2 17.8253 2.23203 10.2933 -8.67083 8.1401 4.47273 +502 1 12.2919 0.0227122 10.1361 2.29147 -28.3523 -7.04943 +503 2 11.4789 0.3695 10.4906 -11.5623 8.87459 2.77288 +504 2 12.9485 0.705533 10.1424 9.22066 20.6222 4.35768 +505 1 10.3653 9.79669 12.372 -8.95345 -3.20907 -9.5203 +506 2 11.0695 9.83133 13.0162 9.21286 -1.60231 7.36796 +507 2 10.2442 8.85709 12.1552 0.446892 6.98856 4.38647 +508 1 0.537603 2.83987 7.02256 -3.09155 -21.8169 -17.6677 +509 2 0.689112 3.48917 7.69969 6.81735 5.32415 12.4887 +510 2 0.745143 1.97019 7.39814 0.967775 11.9311 3.78775 +511 1 0.407687 15.2844 6.91114 -10.1505 12.0239 22.1786 +512 2 0.487576 14.9005 7.81264 0.770838 8.15944 -16.8401 +513 2 0.754028 14.6482 6.29753 4.41733 -17.9374 -4.37366 +514 1 17.0108 7.01877 15.2726 9.75856 -4.98107 -8.16179 +515 2 17.7945 7.53845 15.0774 -4.62906 13.8031 -0.900924 +516 2 17.4019 6.14594 15.3485 -8.43732 -9.20439 7.91006 +517 1 9.04118 12.4266 8.12126 20.8625 -13.8276 -21.4288 +518 2 9.31201 11.8186 7.41014 14.8696 5.22508 9.07579 +519 2 8.11227 12.3461 8.03152 -32.7632 10.2849 9.08461 +520 1 1.26557 1.8876 3.02782 9.65045 8.01813 1.36118 +521 2 0.751817 2.27104 2.32199 -7.08934 -1.28284 -8.05339 +522 2 1.78864 2.63408 3.35807 -1.4257 -10.3882 4.86199 +523 1 4.12138 15.1091 9.73113 11.5132 -2.98862 0.0844269 +524 2 4.08037 15.3711 8.80771 -6.64563 1.38763 -1.25331 +525 2 5.02377 14.7713 9.82789 -5.61093 0.302526 6.22582 +526 1 7.21558 2.18454 14.596 -3.30246 -13.7461 5.2135 +527 2 6.95017 1.78255 13.7582 4.82488 2.3919 4.06302 +528 2 7.77929 2.92256 14.3836 3.82883 9.51482 -6.38734 +529 1 18.5827 14.6796 2.1698 -24.3208 -2.36026 -2.50397 +530 2 0.827663 15.0286 2.10654 6.16868 9.29818 1.18622 +531 2 17.9285 15.4101 2.10387 15.0339 -9.50868 3.05979 +532 1 9.96457 2.76705 12.9307 -6.0306 9.60441 -0.715471 +533 2 9.81933 2.16697 12.1996 2.81266 -10.505 -5.71659 +534 2 9.23975 3.40361 12.8511 1.73763 -0.77134 6.44595 +535 1 2.86173 8.92609 13.0404 7.24036 -2.57601 -2.21085 +536 2 3.32754 9.76259 12.8684 -5.41233 -1.95407 1.34833 +537 2 3.53569 8.30272 13.3558 -0.616664 3.71534 -0.977901 +538 1 3.21505 8.40688 3.66968 15.7234 22.1036 -19.602 +539 2 3.76887 9.07341 3.20135 -16.7118 -11.852 2.14794 +540 2 3.39007 8.60458 4.57891 -0.363765 -1.98929 20.9454 +541 1 5.60252 7.19004 8.53175 5.86958 -4.86959 9.5617 +542 2 5.84506 6.27445 8.70563 -2.01066 -2.63063 -12.6146 +543 2 5.1548 7.42343 9.34691 -7.32508 9.6882 0.185442 +544 1 14.8904 1.34267 1.9851 -2.44355 -11.2972 17.4528 +545 2 14.6303 2.11535 2.51846 2.91157 0.487188 -15.3266 +546 2 15.025 1.53806 1.05778 2.17575 14.4946 -4.76666 +547 1 8.30348 15.1948 0.839181 1.62975 3.11742 -15.2912 +548 2 9.05101 15.1086 1.44328 -1.42893 -5.28711 5.64984 +549 2 7.54504 14.6965 1.17349 5.50357 -4.17517 7.24781 +550 1 15.6062 1.34647 7.22998 12.9139 6.24135 5.03718 +551 2 15.0343 0.764422 6.7383 -10.7397 -5.17 -5.22658 +552 2 15.1371 2.18077 7.35367 -5.42005 -2.19365 2.65732 +553 1 4.96367 13.0608 18.5175 -8.25637 -3.65043 -17.7207 +554 2 5.34878 13.2483 0.722802 8.16177 0.261597 12.4464 +555 2 5.65153 13.2431 17.8644 -2.22894 4.298 3.81358 +556 1 15.3614 8.50445 18.1376 -9.02232 -8.38547 12.9254 +557 2 15.7319 9.00583 17.4156 5.20151 10.9324 -8.24127 +558 2 15.1687 9.14311 0.198883 4.58141 -1.82544 -4.44514 +559 1 12.0904 3.05083 18.3558 5.74067 -18.2993 3.78166 +560 2 12.2947 2.48128 0.458355 -7.48955 9.04159 13.408 +561 2 12.4465 2.47277 17.6781 -3.43414 10.0689 -17.6065 +562 1 13.2065 12.6801 5.18634 5.84251 -1.21193 6.01102 +563 2 13.6832 11.8727 4.98831 0.374712 -2.89081 -11.6293 +564 2 13.5252 12.8732 6.07674 -9.12379 3.52213 -1.02632 +565 1 6.05538 7.10808 0.0622478 7.64822 4.54905 2.96407 +566 2 5.99209 8.01824 19.0386 -2.92171 -4.08442 -8.95141 +567 2 5.21644 6.68693 0.272307 -1.20959 2.69213 5.93171 +568 1 17.7218 15.9656 14.99 27.5308 -15.6865 18.0891 +569 2 16.9388 16.4863 15.1181 -14.3434 5.91292 -14.0866 +570 2 17.911 15.7342 14.0701 -14.8265 10.2647 -3.26624 +571 1 13.1712 0.994875 16.5867 2.52549 -1.56274 -3.32645 +572 2 14.0875 0.750433 16.7652 2.07951 0.899412 2.60052 +573 2 12.7522 0.177983 16.2988 -0.931869 -3.47373 4.92885 +574 1 11.0723 14.6005 7.26575 -13.1255 -10.0571 4.65979 +575 2 10.3507 14.0428 7.62559 10.576 8.81418 -2.61622 +576 2 11.902 14.168 7.50495 -4.44994 -4.81764 -1.49609 +577 1 17.5239 8.59779 2.09084 -4.28833 -20.5194 -15.9758 +578 2 16.6824 8.33187 2.48237 1.37862 7.81735 4.46419 +579 2 17.5834 7.99355 1.32242 5.93631 9.11716 13.4418 +580 1 12.3581 7.93946 1.97566 -1.89696 -6.27914 -3.50436 +581 2 11.9505 8.79823 2.04436 -0.86405 10.6038 1.69948 +582 2 11.9097 7.53044 1.22383 5.98844 -6.29912 5.7943 +583 1 11.9176 14.6241 10.3724 -2.87076 17.8373 18.3305 +584 2 12.1889 13.9308 9.80998 14.0474 -22.5763 -16.4958 +585 2 11.017 14.792 10.1004 -10.4734 4.60408 5.02203 +586 1 6.86179 7.0045 15.5825 0.298402 -7.5032 -11.9192 +587 2 7.72978 7.09161 15.1865 4.58892 -5.83629 -5.839 +588 2 6.8806 7.68521 16.2363 -7.39186 11.3873 16.6815 +589 1 8.0061 4.66768 13.4643 -26.1906 -20.4665 -29.1007 +590 2 7.40104 4.82554 12.6933 13.2028 -5.13213 23.0799 +591 2 8.47723 5.469 13.5831 13.4856 24.6751 2.60837 +592 1 13.392 12.1682 14.29 6.21681 3.24263 -1.56593 +593 2 13.3744 11.2127 14.1772 -7.69192 -2.80185 3.02585 +594 2 13.9051 12.489 13.5384 -1.40129 2.2659 -1.62493 +595 1 14.7806 9.45441 7.28093 -11.5532 20.7697 15.955 +596 2 15.4984 10.0862 7.4818 -3.61589 -14.7511 -6.73617 +597 2 14.0294 9.75726 7.82532 9.94729 -6.45384 -10.5104 +598 1 12.6903 16.9959 3.11063 13.9021 -20.0527 -1.11079 +599 2 13.0479 17.2495 3.95961 -1.86196 6.25123 9.18833 +600 2 12.0243 17.6278 2.88206 -13.6174 14.7021 -2.85583 +601 1 1.14933 7.13689 17.4392 -10.8552 -5.82346 1.42608 +602 2 0.254324 6.85235 17.6903 1.68989 10.0465 1.1249 +603 2 1.04814 7.64429 16.6282 0.816381 -0.80389 -4.56811 +604 1 12.8311 5.11146 15.6849 -17.6595 -4.33947 -1.38663 +605 2 13.5036 4.46543 15.459 7.94947 -3.95791 3.77703 +606 2 13.2565 5.97185 15.6774 7.16 2.75079 -1.64654 +607 1 2.47852 3.39671 5.05511 -15.8601 -20.9034 -7.20071 +608 2 1.89248 3.0773 5.76599 4.829 7.89548 -3.4806 +609 2 3.06433 4.04634 5.42706 4.34046 14.9349 7.02505 +610 1 8.31182 11.2281 13.4853 12.2486 -8.92827 -7.03776 +611 2 8.34382 10.988 14.3869 -16.2376 0.866389 37.005 +612 2 9.12412 10.7865 13.2309 -0.249665 2.67206 -26.3927 +613 1 12.9087 1.417 13.3166 0.0274524 -25.355 19.3096 +614 2 13.4801 1.21198 12.5759 3.32243 8.60198 -10.444 +615 2 12.4274 2.20637 13.1188 -4.80778 18.3372 -7.59901 +616 1 6.3961 13.6531 2.14242 21.3539 -7.72513 -19.5528 +617 2 5.86296 14.1246 2.76583 -10.9825 4.85946 19.6126 +618 2 7.0399 13.1177 2.63436 -6.77103 3.35988 1.82582 +619 1 15.9312 6.57282 12.7577 9.39393 9.94387 -6.4398 +620 2 16.4454 7.11896 12.1297 -10.141 -7.43973 7.84454 +621 2 16.2972 6.7745 13.6327 -0.398164 -4.05689 -3.4507 +622 1 16.8338 0.714138 9.59622 -4.58014 7.56344 -3.36861 +623 2 16.786 18.4184 9.78234 2.45796 -8.84878 0.088887 +624 2 16.3762 0.83732 8.75167 2.21028 0.792186 -0.559114 +625 1 6.14371 11.7069 8.36929 2.81279 3.26044 -4.5559 +626 2 5.21452 11.6136 8.62066 2.93526 -5.28935 1.80511 +627 2 6.46143 10.8412 8.07651 -3.38714 0.356066 2.25694 +628 1 2.85881 8.67012 0.388915 2.79689 11.0982 14.7719 +629 2 2.20875 8.30366 18.4701 -9.93413 -28.5632 -26.9968 +630 2 2.30006 9.32334 0.801848 8.26615 13.7996 15.8107 +631 1 10.1321 10.4555 6.53489 -7.45039 0.329373 10.0784 +632 2 10.6046 9.83719 7.10845 -0.190248 -0.487921 -4.0191 +633 2 10.6634 10.5725 5.74842 5.176 -1.34798 -7.09506 +634 1 6.75471 15.7115 6.57125 -11.9312 -6.35937 -2.57899 +635 2 7.17812 16.0056 7.37746 4.55156 8.98271 2.0062 +636 2 6.84858 16.4009 5.89838 10.4548 -3.40393 4.92981 +637 1 6.44667 13.1112 5.62964 2.65073 6.32881 3.74437 +638 2 6.67596 13.9769 6.00675 -0.0120675 -6.80172 -3.34498 +639 2 5.96115 12.6448 6.31389 0.45756 -2.92263 2.45964 +640 1 16.7937 12.5442 9.80018 5.98989 11.7335 -8.95445 +641 2 16.9887 11.9765 9.05284 -0.702856 -11.4944 -2.64553 +642 2 17.0098 13.4184 9.45025 -4.64512 -2.35242 9.41775 +643 1 6.08081 2.94855 2.81201 5.81343 6.87552 13.2918 +644 2 6.21399 3.88965 2.59312 -1.02666 -12.0092 -4.68113 +645 2 5.77459 2.45978 2.03916 -1.91968 5.61369 -5.09877 +646 1 10.8797 3.26448 3.27711 -5.41025 -2.45564 -6.20574 +647 2 10.301 3.99846 3.49319 -0.0844139 2.78359 4.78679 +648 2 10.5123 2.93026 2.45079 3.61554 -5.12824 0.569032 +ITEM: TIMESTEP +40 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.73557 7.01799 17.9607 21.964 -6.69295 -3.41675 +2 2 7.837 6.97936 18.244 -22.923 1.28376 8.03757 +3 2 8.84363 6.25859 17.3828 1.27689 0.0651665 -4.69765 +4 1 18.6647 8.30209 6.83035 -0.644058 3.99523 -48.5507 +5 2 0.211245 8.12789 5.86514 -9.60619 8.91963 25.083 +6 2 0.465598 7.58914 7.26037 9.90688 -14.2806 22.1152 +7 1 8.44495 18.6364 6.8238 -19.0399 -0.344231 6.51496 +8 2 9.34052 0.200584 6.61788 21.6732 5.78047 -4.99449 +9 2 7.92466 0.711623 6.44684 1.16681 0.183702 -1.11302 +10 1 6.56005 1.80411 11.6838 -38.7214 4.43655 14.793 +11 2 5.75321 2.272 12.0538 30.5925 -16.6996 -9.96133 +12 2 6.22943 0.898268 11.5156 6.32845 11.0599 0.0206858 +13 1 7.08366 5.68816 2.38617 22.7225 -30.9477 -12.475 +14 2 6.58152 6.21056 2.95839 -27.8787 23.1579 37.4024 +15 2 6.84697 6.04683 1.54845 0.038941 9.08719 -25.9535 +16 1 16.22 10.2137 16.0864 41.4588 -5.13522 6.23048 +17 2 17.1921 10.3703 16.208 -28.8473 -8.8876 -9.54756 +18 2 15.8271 11.0171 16.4051 -13.971 12.6367 2.51598 +19 1 10.6448 14.9575 2.33364 6.27542 19.2207 -0.856148 +20 2 10.5562 14.6084 3.22703 2.40752 -4.54155 -3.02292 +21 2 11.1101 15.8129 2.46012 -8.85901 -18.4002 -3.84051 +22 1 17.1611 8.2532 10.553 -11.2529 -0.0170881 12.6501 +23 2 16.8393 8.94572 11.1538 -1.12797 -5.57792 -5.31501 +24 2 17.9446 8.61302 10.1436 10.8511 4.56282 -2.94704 +25 1 14.7728 15.897 16.3892 -19.7826 14.9663 0.46496 +26 2 13.8411 16.2137 16.4626 21.4068 -5.53606 -7.5515 +27 2 14.9622 15.5552 17.2653 -0.403084 -10.0705 4.87845 +28 1 12.136 13.4022 0.475357 -11.3959 -2.02194 -12.751 +29 2 11.9408 13.3873 18.1673 8.9331 -2.53085 4.8524 +30 2 11.4037 13.9022 0.849725 6.62825 2.84238 11.8203 +31 1 9.29338 5.44787 4.01163 24.6694 12.616 -29.9837 +32 2 8.80858 5.1972 4.76287 -21.098 -14.9153 34.0625 +33 2 8.63435 5.49966 3.31701 -4.42724 -1.21089 -8.36553 +34 1 1.79376 4.18976 11.6282 4.46954 -46.7602 7.51249 +35 2 1.70048 5.09501 11.8512 -4.37305 32.1952 10.6933 +36 2 2.09275 3.70286 12.4334 -4.9207 12.4729 -20.4441 +37 1 2.01732 6.80615 8.34226 1.64844 10.8358 -0.647304 +38 2 2.37448 7.3471 9.0762 -2.77819 -13.6149 -8.9692 +39 2 1.92609 5.89421 8.65385 1.80745 6.26657 1.98394 +40 1 5.38901 4.42498 7.95307 14.0474 9.0477 19.097 +41 2 5.49608 3.48465 7.79451 -4.39314 -7.26091 -3.25333 +42 2 4.79389 4.80722 7.31869 -10.598 0.276841 -18.5158 +43 1 3.29732 2.94293 17.5086 17.2208 -30.0882 -17.6092 +44 2 4.02601 3.30007 16.978 -4.8938 2.423 1.99348 +45 2 2.81217 3.66256 17.8655 -12.7512 26.7583 13.4218 +46 1 7.44366 5.31542 6.10005 -2.04578 -15.3999 -38.6663 +47 2 8.07874 5.97061 6.33436 13.5587 20.8049 21.0336 +48 2 6.95124 5.08125 6.86821 -11.582 -6.53412 22.3247 +49 1 9.78574 7.01841 12.0035 -14.224 -5.31732 -23.9819 +50 2 10.3573 6.41663 11.5027 -2.93892 5.75769 9.08141 +51 2 9.02058 7.16943 11.392 19.9248 1.87014 17.2782 +52 1 14.0222 3.60384 8.07347 21.1656 -3.6634 36.3987 +53 2 13.9951 4.24089 7.37961 -2.65045 17.7741 -13.562 +54 2 14.5465 4.02482 8.8088 -19.0215 -13.1146 -21.9867 +55 1 4.60432 17.1743 3.97092 -4.17058 -8.50894 9.4345 +56 2 5.51528 17.3741 4.10719 24.7317 1.00316 8.45766 +57 2 4.31895 17.8257 3.35422 -16.1123 9.67587 -20.1592 +58 1 16.4938 16.6102 10.1803 -22.58 10.2442 28.8776 +59 2 15.6971 16.8258 10.7464 27.0105 -10.9286 -19.8859 +60 2 16.1827 15.9878 9.51957 -5.57273 -0.00226425 -4.98818 +61 1 1.9645 4.84741 0.368078 -14.0488 -12.8308 -13.2388 +62 2 2.69854 5.15593 0.879033 14.2396 9.43314 15.7095 +63 2 1.5724 5.64147 0.000503254 -0.0595591 4.00938 -5.12573 +64 1 11.6747 13.3071 16.3147 -7.05005 22.2307 18.0491 +65 2 11.0866 12.5598 16.3919 -3.1788 -17.5748 -3.92498 +66 2 12.2584 13.1709 15.5748 2.75178 -8.36686 -13.1919 +67 1 10.131 11.038 16.8986 -21.0542 26.9507 -1.58256 +68 2 10.4848 10.1706 16.8573 15.2828 -28.4038 0.505132 +69 2 9.17797 10.924 16.7712 4.48065 0.743861 -0.190366 +70 1 11.7352 17.4666 13.4614 -1.07936 25.6776 8.56908 +71 2 12.4835 17.2209 12.9203 3.02318 -9.35187 -8.63799 +72 2 11.8077 18.4454 13.5145 -0.798306 -16.7366 -1.43427 +73 1 6.39395 9.3313 12.2301 16.0138 21.1557 17.835 +74 2 6.78657 8.92292 11.474 4.59605 -10.3711 -18.9433 +75 2 7.12055 9.89522 12.5742 -21.4515 -7.31443 1.84288 +76 1 16.2436 12.8045 2.69297 9.19112 6.28957 -1.09055 +77 2 17.1119 13.1995 2.45018 -21.0084 -1.00278 4.98407 +78 2 15.5746 13.5129 2.79044 13.212 -4.74068 -2.98151 +79 1 0.66547 12.6008 5.89246 44.3801 0.278469 12.8923 +80 2 0.944588 12.4662 4.9918 4.15776 -1.70344 -11.3497 +81 2 18.3844 12.6561 5.85431 -44.3715 7.63264 -5.03051 +82 1 5.23201 16.4301 18.4413 -23.1671 11.3407 -2.74477 +83 2 5.81563 15.7669 18.0873 14.8521 -9.88299 1.40517 +84 2 5.51268 16.7513 0.656182 8.57816 -5.72834 2.04059 +85 1 0.568352 7.66823 4.13077 -28.9792 -20.0076 22.3714 +86 2 18.6051 8.03762 3.49503 -7.9612 4.34402 -11.87 +87 2 1.4037 8.01472 3.91532 39.463 15.435 -13.2826 +88 1 3.11888 8.95318 6.49662 60.4725 2.42495 -6.82714 +89 2 3.7308 8.46704 7.08062 -7.96075 9.2896 -8.18079 +90 2 2.27986 8.68504 6.76207 -50.4171 -10.8396 15.4956 +91 1 7.30368 10.3509 16.2473 20.2996 0.0228567 -17.1566 +92 2 6.66358 10.504 15.5564 -7.99994 0.888183 -0.524161 +93 2 6.82737 10.217 17.0566 -12.2765 1.21271 14.6854 +94 1 11.12 1.01485 5.00375 -0.0102216 2.84952 14.1843 +95 2 11.0857 1.87302 4.56078 2.3673 -3.0702 -4.20032 +96 2 10.7324 0.367128 4.41621 -3.73217 -2.39612 -13.1961 +97 1 4.37027 2.7904 13.2033 3.18584 17.5115 -8.99997 +98 2 4.79356 3.08499 14.0007 6.25053 15.0735 9.59097 +99 2 4.18046 1.89747 13.4272 -8.57413 -32.1756 -2.785 +100 1 8.40183 10.1302 1.81819 -11.3119 21.1596 -20.1509 +101 2 8.22596 10.8234 2.46526 3.55036 0.443395 1.34914 +102 2 8.74004 9.40086 2.30376 11.7587 -22.7948 15.5041 +103 1 10.4641 1.71908 15.5611 14.2583 -4.22402 3.33599 +104 2 11.4066 1.52258 15.371 -17.8532 5.60176 1.9802 +105 2 10.08 2.13518 14.7824 5.57904 -1.0897 -7.54918 +106 1 2.70316 12.9014 7.80195 3.19617 10.9991 1.8073 +107 2 3.3212 13.5754 7.49282 0.460726 -0.40643 1.73206 +108 2 2.13336 12.7538 7.04495 -5.07282 -6.75217 -1.11681 +109 1 3.70861 11.6625 5.14703 20.6482 18.5599 0.117703 +110 2 3.55555 10.8287 5.56068 -6.18613 -18.2271 10.4705 +111 2 3.04771 11.7826 4.47739 -15.5561 1.61657 -8.41129 +112 1 6.75631 14.4548 16.9127 8.94674 -1.78931 -0.924301 +113 2 7.71443 14.3361 16.9267 -6.94418 4.38523 0.882829 +114 2 6.52635 14.6721 16.0018 -2.96874 0.297136 0.835917 +115 1 14.1768 14.5549 3.37546 -9.20747 -5.25648 5.53536 +116 2 13.5738 15.2994 3.18581 6.88801 -12.7747 3.05988 +117 2 13.7349 13.9262 3.9882 4.46288 16.3838 -11.0193 +118 1 8.36945 18.1316 16.043 -50.6417 14.5597 -0.377943 +119 2 8.83326 17.39 16.374 32.1095 -21.5179 4.54953 +120 2 8.87194 0.178112 15.6264 24.4627 6.71878 1.23367 +121 1 4.74402 1.66109 4.92978 -19.7446 -31.5867 36.4561 +122 2 3.83516 1.95374 4.92736 -8.28526 7.01041 1.88485 +123 2 5.14187 2.10852 4.23181 25.7722 28.9669 -41.4039 +124 1 15.0327 12.6922 16.4463 -14.1895 -13.4373 -36.9651 +125 2 14.5853 13.1594 17.1179 -4.44761 17.5587 33.5367 +126 2 14.3173 12.6168 15.7704 28.0544 -5.79477 6.54775 +127 1 15.7455 18.4472 16.8494 -36.7721 -17.2537 -45.0168 +128 2 16.3082 18.5742 17.5575 42.6678 12.9246 46.9817 +129 2 15.6033 17.4929 16.845 -6.46687 1.33922 -4.84851 +130 1 1.19925 1.17644 16.5482 3.81725 -14.252 -17.647 +131 2 1.9494 1.76296 16.5282 11.9166 8.08174 5.38627 +132 2 0.720072 1.41993 17.3243 -10.8728 8.87917 17.8692 +133 1 18.1194 4.51517 15.8978 -9.12682 11.3324 16.5545 +134 2 18.3907 3.99589 15.1624 6.35448 -14.0345 -18.3092 +135 2 0.212938 4.54105 16.5062 3.72114 1.23331 1.72655 +136 1 12.2575 16.9791 16.1441 20.307 19.4582 -44.4732 +137 2 11.5756 16.5974 16.6415 -35.2707 -20.5418 23.5889 +138 2 11.9443 16.955 15.2053 9.79722 2.45701 21.3583 +139 1 15.9948 2.53341 18.0767 10.9381 -15.7258 5.9061 +140 2 15.4972 3.23449 18.4655 -6.78731 22.0319 12.1926 +141 2 15.8185 2.63494 17.1497 -1.81081 -2.22204 -19.1287 +142 1 6.71322 13.8205 10.2184 4.21251 -0.72826 -19.8354 +143 2 6.51318 13.5527 11.1172 -1.15071 -8.01371 4.0626 +144 2 6.63912 13.0526 9.6212 -3.83744 4.98216 12.3358 +145 1 10.1462 18.2988 2.74675 -22.097 -20.0437 20.6404 +146 2 10.3757 0.350258 2.15404 6.85623 19.4082 -18.4799 +147 2 9.18692 18.1396 2.61143 20.6475 -0.265938 -2.33946 +148 1 3.01179 17.7216 6.11391 16.3646 11.1083 -7.5066 +149 2 2.20644 17.7129 5.60578 -13.7656 -5.82691 -3.27397 +150 2 3.67703 17.9821 5.44947 -4.29715 -10.1951 11.4126 +151 1 12.5763 16.9057 8.00279 34.6812 6.34788 -19.799 +152 2 11.842 16.3339 7.82778 -18.535 -10.6459 7.52248 +153 2 12.4277 17.4882 8.74445 -13.6741 4.98834 7.73701 +154 1 14.8867 15.2801 8.21669 15.2681 -20.6133 -0.236719 +155 2 14.2473 15.9935 8.15265 -4.83203 2.49296 -8.82369 +156 2 15.4177 15.201 7.39136 -14.8487 16.0275 12.7595 +157 1 17.673 18.2386 0.358056 6.39969 9.72416 1.64776 +158 2 18.5627 17.8182 0.243387 -17.6184 17.4743 1.20562 +159 2 17.7074 0.56338 0.562155 11.394 -25.7036 -4.78753 +160 1 0.840605 10.4115 1.35744 37.4959 50.4012 -24.017 +161 2 0.0672579 9.99096 1.64345 -42.7842 -22.4511 10.6341 +162 2 0.58692 11.2092 0.808654 3.76922 -28.1369 19.051 +163 1 1.6843 12.2358 3.38047 -6.18426 -19.2714 -7.57792 +164 2 1.35621 11.4726 2.83119 9.65923 28.3457 4.48748 +165 2 1.68469 13.0653 2.87986 -2.69674 -10.3555 -4.68476 +166 1 0.583101 17.235 4.89274 4.80321 -10.1773 15.6529 +167 2 18.7212 18.0548 4.74777 -0.344371 -10.7938 17.6071 +168 2 0.457865 16.8228 5.79389 -3.26711 20.5272 -26.9728 +169 1 1.10197 0.931397 9.43269 -15.4399 -19.3078 -9.02275 +170 2 1.25908 0.443364 10.2575 0.781623 10.2528 -2.87546 +171 2 0.281175 0.525265 9.08113 16.3171 12.9297 7.39947 +172 1 16.7532 2.33623 13.2905 -6.48112 -9.83965 38.5991 +173 2 16.8955 2.59135 12.4052 6.16672 6.51778 -37.0535 +174 2 16.4416 1.41783 13.3009 4.47832 4.66932 -0.969858 +175 1 2.60624 15.8504 12.1681 -27.4943 19.2901 -21.9402 +176 2 3.16839 15.391 12.7532 19.3125 -15.6847 20.968 +177 2 2.92961 15.6774 11.278 4.5792 -4.36857 -3.32021 +178 1 16.4212 15.6424 6.03078 2.33398 -27.7044 12.4884 +179 2 17.3276 15.7008 6.32 9.77501 -6.8374 8.24343 +180 2 16.3266 16.4053 5.49767 -10.7497 25.3256 -21.0495 +181 1 5.80196 5.07502 11.792 -7.0375 5.38003 9.08436 +182 2 5.27256 5.62589 12.4097 12.9595 -6.51078 -10.685 +183 2 5.4277 4.18781 11.8485 -2.70068 5.27459 0.5345 +184 1 15.1729 4.86274 0.750774 -1.10571 10.9128 -33.6343 +185 2 15.2042 4.59535 1.64712 -4.27265 -9.78555 34.3171 +186 2 14.3466 5.34824 0.643665 4.19718 -3.49047 -1.12139 +187 1 16.3347 16.3636 2.07743 2.17372 -8.94604 27.567 +188 2 16.248 16.684 3.01162 -4.2135 -4.93901 -27.3972 +189 2 16.5997 17.1143 1.55727 4.53602 12.7734 -5.95158 +190 1 0.261441 4.84804 3.8055 -0.147017 -56.3045 13.8461 +191 2 0.475233 5.74211 3.84367 9.07909 56.4423 -0.745388 +192 2 0.927869 4.41838 4.37361 -9.48651 2.83213 -9.85838 +193 1 2.95802 15.0603 15.1014 -0.943114 0.172839 -27.3629 +194 2 2.80338 14.7297 15.9709 -3.98201 -9.31011 23.138 +195 2 2.36314 15.8122 15.0164 6.10514 4.60789 3.27938 +196 1 1.13815 14.652 9.54287 -29.9359 -26.3887 42.7894 +197 2 1.85794 14.2975 9.07203 33.137 -5.88851 -26.0645 +198 2 1.02375 13.9289 10.2175 -6.6715 26.0405 -18.8729 +199 1 13.5762 16.6063 11.5459 8.2131 -23.6119 0.793767 +200 2 13.33 17.296 10.9485 -9.11427 22.0857 -7.2987 +201 2 13.1805 15.8285 11.1175 -0.169415 1.89227 9.19008 +202 1 4.67714 1.46335 0.758621 16.4224 4.90719 -8.19047 +203 2 4.16601 2.0159 0.158762 -4.20381 1.9839 -0.0593356 +204 2 4.09672 0.7797 1.07984 -10.7002 -7.55851 6.47825 +205 1 1.4518 18.552 11.8572 6.2605 -28.7314 5.6203 +206 2 1.30143 0.363179 12.6934 -0.382356 1.32639 0.00372943 +207 2 1.68394 17.6168 12.0771 -1.80479 24.861 -1.36748 +208 1 11.5075 10.1198 4.02095 -18.4811 -8.70186 23.5865 +209 2 11.1917 10.5684 3.24759 -2.79925 6.67004 -19.1711 +210 2 12.4478 10.2129 4.02159 23.6747 0.339266 0.782627 +211 1 8.31226 12.1774 3.6909 13.3967 -8.0925 -50.6166 +212 2 9.08853 12.6634 3.95409 8.19758 6.83683 10.985 +213 2 7.73108 12.1161 4.40989 -25.5486 3.81511 42.2514 +214 1 14.4234 4.01167 3.27932 -6.39999 -0.808874 -15.5703 +215 2 15.0318 4.04602 4.01015 9.81333 2.6424 13.2185 +216 2 13.6949 4.61166 3.47516 -0.628596 -1.04819 4.76047 +217 1 5.60276 1.68001 7.51543 46.6974 51.3536 -38.165 +218 2 4.99884 1.09753 7.87161 -47.5789 -43.021 28.4342 +219 2 5.32972 1.80197 6.58421 6.01087 -7.11276 10.7862 +220 1 17.8847 1.08156 4.86879 -16.2479 -18.084 1.95698 +221 2 18.6198 1.37964 4.35055 14.6356 14.0949 -7.48199 +222 2 17.763 1.66674 5.61639 2.20316 6.60999 2.39214 +223 1 6.81142 9.41573 4.49306 -0.655622 0.432156 7.98772 +224 2 6.876 9.60924 5.45033 2.30801 -5.82211 -14.8304 +225 2 7.69814 9.2085 4.16641 0.21776 -0.211816 8.23149 +226 1 2.64622 14.9044 1.97705 -19.6169 -6.34757 32.4999 +227 2 3.24366 14.6749 2.7111 -2.05224 3.38495 -12.0409 +228 2 3.14951 14.9574 1.1885 18.3224 0.185563 -21.7099 +229 1 17.3026 12.9105 13.1506 5.97988 10.8617 -4.35729 +230 2 16.4943 13.3715 13.3508 -17.5214 -4.76439 4.13034 +231 2 17.8495 13.6655 12.9025 6.83053 -7.65676 -2.15198 +232 1 14.953 10.5544 1.38215 35.2581 29.1908 17.9973 +233 2 15.5812 11.2612 1.74238 -25.4064 -29.0048 -15.0024 +234 2 14.0938 10.9575 1.42777 -9.92862 1.12257 -1.65093 +235 1 5.7132 6.77849 4.57909 1.57168 19.8101 -12.7812 +236 2 6.1646 7.64962 4.62346 -11.1008 -12.4177 -0.29751 +237 2 6.30742 6.13992 4.97063 6.93571 -3.41618 11.3539 +238 1 8.02607 8.31482 10.3199 -6.67367 -6.11991 -5.1902 +239 2 8.5826 9.1064 10.2496 0.567217 -7.04018 -13.4516 +240 2 7.81744 7.96553 9.42928 8.80325 8.4252 13.4279 +241 1 13.463 18.3942 5.75922 18.2094 9.72717 -25.7917 +242 2 12.7029 0.253225 5.44631 -3.25776 3.56949 4.30859 +243 2 13.1448 17.7819 6.40042 -11.4028 -12.4364 22.7676 +244 1 0.157572 2.62906 0.18715 -8.27583 -44.4001 -2.30616 +245 2 17.9404 2.90438 -0.139246 -4.84787 10.7772 1.25282 +246 2 0.728557 3.33866 0.428035 8.4047 29.5908 2.16632 +247 1 12.7834 11.0467 9.74512 50.2143 -37.9981 33.2215 +248 2 11.9361 11.0491 9.39224 -54.8114 3.18277 -19.015 +249 2 12.8684 10.1188 10.1004 3.84712 25.3375 -10.5627 +250 1 0.745434 12.1889 11.0782 -25.5268 2.00553 -1.18025 +251 2 18.4134 12.2219 11.1204 10.6569 -0.780029 -7.62666 +252 2 1.00048 12.4147 11.9671 12.4315 1.99225 10.3147 +253 1 5.08453 7.29937 13.4403 2.24753 -3.99956 1.86213 +254 2 5.64891 7.85147 12.8757 -3.98378 2.58677 10.115 +255 2 5.52437 7.26557 14.3066 0.821915 -2.02828 -9.69703 +256 1 1.22699 6.88005 11.8698 42.6355 29.3241 27.8417 +257 2 0.513102 7.24659 11.3736 -15.3023 8.70694 -9.89945 +258 2 1.76616 7.68013 12.1994 -27.3906 -36.7234 -16.475 +259 1 15.5048 9.56381 12.3059 14.0365 -21.5239 -8.17825 +260 2 15.0446 10.3738 12.2505 -11.2614 35.3449 -7.27588 +261 2 15.2981 9.243 13.1696 0.51668 -8.53923 17.0206 +262 1 16.6213 12.8097 5.50479 11.7533 -20.9364 35.7876 +263 2 16.4281 13.7341 5.58129 -4.58024 20.9264 -6.48074 +264 2 16.496 12.5383 4.61195 -7.15835 1.38375 -28.6034 +265 1 6.25272 9.92074 0.051253 25.5558 -5.2213 19.2814 +266 2 5.65499 10.4134 0.617489 -6.63873 2.74854 -0.55683 +267 2 7.09279 9.88715 0.575545 -19.794 1.5448 -11.6918 +268 1 12.3217 6.11544 4.06855 24.0308 27.0278 -26.8963 +269 2 12.2667 6.69224 3.25542 -0.750296 -12.6773 27.7542 +270 2 11.603 5.51542 4.01585 -23.4349 -14.6267 -3.11795 +271 1 0.228308 12.8043 0.188232 11.1572 0.898125 2.61316 +272 2 0.191448 13.5221 0.829575 -7.01271 0.62324 2.49922 +273 2 18.423 13.1312 18.0517 -4.48315 2.42872 -7.20237 +274 1 3.7281 18.597 8.57641 -7.3642 13.4464 17.6561 +275 2 3.55952 18.0214 7.8301 -5.82536 1.28732 -6.71467 +276 2 2.87154 0.379366 8.79158 11.2944 -8.20129 -4.53508 +277 1 7.45075 17.3023 4.47746 -12.4687 -31.8552 -5.62811 +278 2 7.62794 18.1881 4.68695 9.53175 40.2972 16.7849 +279 2 7.50734 17.3052 3.52795 -1.99738 -6.99443 -12.8094 +280 1 9.24058 17.0897 12.2501 -24.9009 9.53262 -6.54721 +281 2 9.25026 16.4035 11.594 -4.50925 -12.7792 -11.7902 +282 2 10.1098 17.0766 12.5981 28.7243 3.47903 16.8433 +283 1 13.2876 12.9366 7.99409 13.1339 47.0026 -12.7195 +284 2 13.3658 12.2269 8.61754 6.78146 -9.97429 11.7811 +285 2 13.946 13.6564 8.215 -16.5737 -23.9385 -2.8436 +286 1 14.9278 2.97205 15.3542 -22.0243 3.95222 27.314 +287 2 14.2978 2.24466 15.255 3.92553 0.418625 -2.59085 +288 2 15.495 2.9795 14.6023 14.212 -3.72656 -21.152 +289 1 9.88733 15.5502 16.9939 -6.96656 2.06857 9.21519 +290 2 10.3024 14.7219 16.7214 3.24805 0.519307 1.1538 +291 2 9.47388 15.4159 17.8681 4.17307 -0.448199 -10.2742 +292 1 11.3272 8.33778 16.5655 -12.1447 -4.13113 3.07889 +293 2 10.5941 7.97459 16.029 11.4521 -0.447246 11.036 +294 2 11.3675 7.80686 17.3849 -1.98947 6.30133 -12.9317 +295 1 3.91087 18.2078 16.7523 8.10648 -24.8729 2.7978 +296 2 4.29329 17.4751 17.2712 -2.30537 5.45923 -13.1249 +297 2 3.83261 0.235403 17.405 -4.96911 23.3333 9.68201 +298 1 2.20524 4.16671 8.93127 -30.922 4.24465 -33.9389 +299 2 3.10409 4.18899 8.66341 29.7515 -2.18627 -0.590115 +300 2 2.16419 4.10976 9.8632 4.73941 -5.36165 36.7803 +301 1 9.8752 10.3748 9.71669 16.1383 -34.8575 15.3318 +302 2 9.43878 11.1114 9.34267 -12.9257 32.2344 -10.6144 +303 2 10.0704 10.5459 10.6459 0.567735 2.49547 1.17829 +304 1 9.70603 0.859612 10.8594 11.2219 3.05072 8.41213 +305 2 9.26848 0.0594607 11.2011 -2.07101 7.3453 -10.3505 +306 2 9.18365 1.30902 10.1791 -6.8322 -10.1071 2.86508 +307 1 9.20299 15.1273 10.2305 31.122 11.5717 5.63223 +308 2 8.76871 15.6899 9.60445 -9.85228 15.7354 -8.32779 +309 2 8.63472 14.3875 10.3233 -23.0991 -20.0884 3.25194 +310 1 0.96837 9.47951 10.2963 -70.5876 8.50765 14.6853 +311 2 0.835229 10.4182 10.5095 11.9906 -6.34251 -2.52384 +312 2 1.84768 9.33537 10.0919 56.817 -0.102153 -14.2985 +313 1 16.9556 4.85371 8.1764 15.2186 15.5475 -39.5257 +314 2 16.4324 5.61135 8.41217 -10.5813 9.18021 7.17639 +315 2 16.8473 4.22258 8.84986 -2.43363 -23.5078 29.961 +316 1 14.6968 14.7113 0.249291 21.1749 6.84176 -19.9636 +317 2 15.2416 15.0749 0.948116 1.7369 4.80193 6.96981 +318 2 13.9408 14.343 0.670519 -22.6431 -9.26918 11.3127 +319 1 3.62773 11.0513 9.55661 13.6415 -11.4582 11.5887 +320 2 3.64622 11.3868 10.4653 -1.2087 2.23818 -2.33891 +321 2 3.18854 11.7052 9.01978 -9.00441 8.94912 -6.83793 +322 1 11.1486 10.7845 1.39435 -11.9859 -27.9615 14.113 +323 2 11.4982 11.6036 1.1014 8.88176 28.2378 -14.4203 +324 2 10.2242 10.7355 1.11217 4.88573 2.00485 1.40976 +325 1 13.1617 7.12114 12.7848 27.9985 9.25187 0.204961 +326 2 14.1485 7.05909 12.8492 -22.0105 -1.86773 -1.16605 +327 2 12.8387 6.22307 12.8528 -4.13181 -6.51108 -0.646654 +328 1 9.62686 1.89618 0.979059 -11.1933 -2.25437 -17.4068 +329 2 8.86583 1.44793 0.536192 15.085 16.0595 8.12302 +330 2 10.1008 2.43338 0.313674 -4.24921 -13.4265 6.88026 +331 1 10.6169 13.5248 4.60784 -18.2432 -3.19473 -12.9411 +332 2 11.3551 12.9251 4.5569 15.1862 -3.85234 3.34493 +333 2 10.6581 13.9134 5.47279 3.49634 8.81883 14.723 +334 1 14.3649 1.74425 10.9305 5.54735 -12.1033 0.31392 +335 2 15.2006 1.47853 10.5325 -1.1471 -9.04293 -1.43649 +336 2 14.4646 2.6903 10.9924 -3.65076 12.6994 -0.169483 +337 1 14.6084 12.2765 11.688 7.48969 -0.0414248 52.7612 +338 2 15.3889 12.4412 11.1797 12.3837 0.874018 -20.9659 +339 2 13.8613 12.0797 11.1652 -22.2598 -6.69151 -32.5036 +340 1 8.22131 5.06515 9.81151 31.4859 -23.4564 -24.7693 +341 2 7.50576 5.35441 10.3398 -29.672 2.17434 15.6894 +342 2 8.09879 4.11038 9.58602 -2.47918 22.6636 6.16193 +343 1 1.53723 16.856 18.3772 -4.91865 -38.0309 19.5229 +344 2 1.81973 17.2424 17.568 8.52952 11.4507 -22.0862 +345 2 1.68062 15.8825 18.2332 -2.55663 27.9439 5.8223 +346 1 1.48989 17.248 15.3251 -39.2991 7.69546 7.77355 +347 2 1.63979 18.1273 15.7491 -10.9611 -20.0854 -9.27397 +348 2 0.505086 16.9983 15.3475 43.8724 16.6347 0.193712 +349 1 3.67894 5.68848 6.10927 6.21387 -9.44646 -9.55971 +350 2 3.15123 6.21186 6.69497 -13.0277 9.84767 14.8728 +351 2 4.18038 6.32117 5.58457 4.58642 -2.3545 -2.10993 +352 1 12.397 9.46521 14.1943 -11.4291 42.6821 2.6577 +353 2 12.6884 8.68898 13.7764 17.0449 -39.3969 -17.6043 +354 2 12.207 9.20402 15.087 -1.24705 -6.16332 16.3323 +355 1 4.0418 15.2774 6.91931 -38.8927 -2.71008 6.44315 +356 2 3.58633 16.0735 6.61178 -2.62598 -4.70343 -0.502904 +357 2 4.94439 15.4914 6.84844 41.7142 6.1892 -4.79175 +358 1 0.605801 8.58372 14.9539 0.254512 0.326548 7.88367 +359 2 0.527439 9.52499 15.1145 -2.4036 7.40824 2.35469 +360 2 1.30759 8.52231 14.3126 8.3049 -1.83762 -9.50966 +361 1 12.9717 8.29262 10.2927 -22.7594 16.3387 10.1639 +362 2 13.6731 7.84025 9.84078 14.5836 -10.6745 -2.92467 +363 2 13.0109 8.02582 11.2281 0.923047 -2.44701 -11.6389 +364 1 15.3232 7.71175 3.53457 4.84131 -0.438878 0.085747 +365 2 14.6048 7.2242 3.18847 -27.3478 1.70601 -26.568 +366 2 15.5504 7.10949 4.22607 20.3905 5.82918 25.2924 +367 1 17.3123 6.68101 0.0543458 25.2448 -11.5383 1.06581 +368 2 16.8643 5.84811 0.208139 -4.52976 -2.78536 3.6701 +369 2 16.6324 7.27442 18.4294 -24.004 18.1506 -8.07094 +370 1 8.88314 6.92259 7.79709 31.0126 27.4325 -12.7619 +371 2 9.82162 7.25311 7.83141 -27.6614 -7.83044 -3.12143 +372 2 8.85418 6.18364 8.38751 -5.1761 -15.9168 16.933 +373 1 12.3742 0.616612 1.23426 0.620177 6.71182 8.7173 +374 2 13.3152 0.448787 1.38768 -5.31542 -0.309906 -0.296651 +375 2 12.0908 0.227811 0.410291 5.35555 -3.35826 -6.33914 +376 1 5.63073 15.1419 14.5354 -14.6404 -24.282 5.65856 +377 2 4.69276 15.2374 14.754 2.80482 -4.42056 0.607876 +378 2 5.89918 16.0006 14.2671 15.2941 25.5531 -11.1631 +379 1 3.85325 6.46699 1.73385 7.01958 -17.0097 2.38606 +380 2 3.51461 7.31896 1.46783 -8.17546 12.9796 -1.79528 +381 2 4.05434 6.54403 2.67764 -3.63249 4.46552 -6.11981 +382 1 3.88854 11.6061 12.3354 -12.5844 1.40703 6.82309 +383 2 4.76337 11.9285 12.5525 8.64878 0.03141 -1.44708 +384 2 3.2838 12.173 12.8501 6.64476 -9.03704 -9.92286 +385 1 5.37483 3.86954 15.8708 7.06931 -74.8011 -5.77053 +386 2 6.14587 3.26348 15.6611 -29.2279 19.2574 6.80998 +387 2 5.70286 4.72315 15.8147 21.5682 55.4234 -2.96121 +388 1 14.3763 10.2794 4.46201 -32.4101 28.4329 49.0365 +389 2 14.443 9.83621 5.32683 0.971611 4.81404 -7.53945 +390 2 14.839 9.74155 3.87936 25.2894 -34.3452 -37.3821 +391 1 7.80918 17.3929 9.15872 22.1479 -28.1908 5.37522 +392 2 6.96403 17.5587 9.551 -17.6194 9.20761 3.63927 +393 2 7.9906 17.9725 8.42371 -6.45863 11.4679 -7.92664 +394 1 4.50911 14.4925 3.93603 -3.72296 -18.8397 -53.7951 +395 2 4.39275 15.3834 4.18687 0.185157 34.2159 14.5975 +396 2 4.6886 13.9787 4.68865 6.61933 -20.0316 37.8242 +397 1 14.2759 7.39669 15.8018 -25.3443 -8.35453 -18.4147 +398 2 15.2098 7.32722 15.7472 31.3188 -3.09541 -3.64929 +399 2 14.1076 7.77613 16.6483 -2.08075 9.82337 20.7866 +400 1 2.98131 18.2876 1.92072 -8.89863 -34.7534 -28.0783 +401 2 2.43865 17.6277 1.38436 23.5626 24.7731 19.3405 +402 2 2.37413 0.302092 2.22775 -14.7638 14.2119 8.82016 +403 1 7.98427 1.62335 4.57287 -40.8947 -0.445207 11.16 +404 2 7.39585 2.15768 4.00383 13.1095 -6.60943 2.01257 +405 2 8.85324 1.63658 4.22836 26.1363 6.2526 -15.7033 +406 1 2.50726 14.1431 17.6951 16.6159 21.4268 -10.1577 +407 2 1.94925 13.5738 18.1946 -18.2656 -19.6261 9.9334 +408 2 3.40865 13.8863 17.9244 2.82527 -4.33175 1.96247 +409 1 0.811695 1.74837 13.8925 -21.7292 3.59652 4.70406 +410 2 0.795118 1.42008 14.8166 -3.87613 7.88135 -16.9479 +411 2 18.5211 1.96459 13.6307 25.6616 -9.0685 11.0917 +412 1 4.4852 18.6484 13.9168 -33.7534 10.3053 3.09674 +413 2 5.3921 18.406 13.9761 25.2496 -8.78408 2.09715 +414 2 4.08373 18.5038 14.7912 8.14506 -1.30426 -6.00867 +415 1 7.12802 0.652367 18.3595 35.0739 -19.2419 -26.0317 +416 2 7.40845 0.19154 17.5185 -9.63956 16.0629 26.4358 +417 2 6.18456 0.683953 18.3433 -21.3742 6.93569 3.25827 +418 1 16.0657 18.4123 14.0301 53.2891 7.60066 12.7833 +419 2 15.2177 18.2242 13.7261 -48.7282 -11.4797 -7.69178 +420 2 16.0808 18.482 14.9966 -9.66087 4.27341 -2.7923 +421 1 10.0672 4.54369 16.2573 46.2132 32.473 -7.3661 +422 2 10.9795 4.93172 16.0704 -30.9355 -10.7562 9.7222 +423 2 10.2805 3.63455 16.4071 -7.05314 -22.7581 -0.39686 +424 1 15.904 17.802 4.45553 44.7656 -19.4466 -14.3322 +425 2 16.4088 -0.0282793 4.41597 5.24747 5.32524 1.83839 +426 2 15.0633 18.045 4.74212 -51.1512 14.4852 15.4733 +427 1 6.99737 17.3998 13.7879 -47.9218 -2.31875 -13.0268 +428 2 7.40243 17.6398 14.5891 19.7576 8.98543 35.5766 +429 2 7.70074 17.2583 13.1843 23.2619 -4.97282 -20.0499 +430 1 13.2941 6.48376 6.64986 8.60711 15.0683 16.7306 +431 2 13.9993 7.1541 6.49159 -11.9149 -19.7057 -4.80273 +432 2 12.8211 6.29295 5.83939 3.46216 6.87198 -11.4398 +433 1 7.76205 2.3443 9.26472 15.7579 10.991 45.3998 +434 2 7.20759 2.25447 10.0765 8.01487 -1.94761 -18.5756 +435 2 7.26048 2.06297 8.52639 -23.6607 -10.4133 -22.8687 +436 1 15.1706 14.8583 13.6757 15.7984 -16.1031 1.44613 +437 2 15.0167 15.231 14.5413 -6.09806 3.71972 9.46304 +438 2 14.6225 15.2955 13.0407 -11.5903 11.1836 -9.13521 +439 1 9.36431 8.31687 3.74781 -9.55399 11.9025 -3.42765 +440 2 10.1518 8.60925 4.20014 9.2003 9.72282 -0.0746101 +441 2 9.3553 7.37835 3.87681 -0.285781 -17.995 1.20514 +442 1 17.7597 13.5616 16.4405 -12.156 -24.6438 9.82021 +443 2 16.8551 13.2283 16.3395 1.48334 1.58847 4.06975 +444 2 17.7289 14.3961 16.0037 5.37456 23.0458 -12.1714 +445 1 4.95841 10.6088 2.75519 -22.9294 18.7883 -14.1686 +446 2 5.66909 10.277 3.27928 16.3083 -8.75526 16.0734 +447 2 4.6114 11.3873 3.23357 6.81328 -15.8641 -4.024 +448 1 3.73362 8.35206 10.1813 3.02598 13.3252 -21.6654 +449 2 3.8939 9.27056 9.86724 -4.6548 -13.2191 9.23973 +450 2 3.49789 8.39898 11.1021 -0.178845 4.23779 13.7606 +451 1 16.0042 7.01418 6.13738 -12.6879 19.8807 -2.17242 +452 2 16.808 7.4479 6.40937 10.6213 6.47779 2.98579 +453 2 16.2019 6.09716 6.06821 5.44302 -25.895 -2.3467 +454 1 15.1221 7.07483 9.10103 -4.15707 -25.1338 32.4641 +455 2 15.7464 7.4872 9.69859 9.03801 3.43378 3.13104 +456 2 15.1481 7.58948 8.33098 1.37226 23.8896 -40.0507 +457 1 6.35284 13.0135 12.8052 -0.193314 -18.9728 -17.7547 +458 2 7.21044 12.6571 13.0708 -4.00291 0.344811 4.20755 +459 2 6.11805 13.741 13.3614 0.492624 18.505 17.8288 +460 1 12.1195 4.49733 13.0969 -26.0004 -21.5883 -29.3264 +461 2 12.1632 4.68913 14.0325 -4.53328 -3.39715 11.6105 +462 2 11.3073 3.93318 12.8667 31.5163 26.387 18.3053 +463 1 11.3554 8.17046 7.8728 -3.27026 2.45633 -4.65198 +464 2 12.0683 7.62612 7.54639 6.23155 -9.6048 -12.5756 +465 2 11.5676 8.24955 8.79484 1.17104 5.44951 18.1694 +466 1 17.1791 10.8374 7.47157 -22.685 17.097 10.0101 +467 2 17.8401 10.2117 7.26521 25.6893 -28.4186 -0.815308 +468 2 17.2004 11.4333 6.72646 -9.08817 8.64759 -4.95169 +469 1 5.26928 18.1244 11.0251 26.2987 0.0330793 2.18763 +470 2 4.69547 17.8637 11.7317 -9.61751 -4.26247 14.7568 +471 2 4.70076 18.4264 10.3375 -16.9 2.57743 -21.8459 +472 1 7.59635 17.5306 1.81531 -10.9531 4.1869 -25.2725 +473 2 7.77056 16.6988 1.31883 2.24077 21.8764 10.5056 +474 2 7.30155 18.2046 1.15131 11.3055 -17.5184 13.1347 +475 1 1.92843 12.8944 13.5862 -6.59595 -16.5477 -16.8116 +476 2 1.43666 12.2821 14.1316 -5.58333 -5.88714 5.06202 +477 2 2.04362 13.6601 14.1181 9.10211 24.5058 14.6097 +478 1 9.63922 6.76943 14.8194 -3.94612 -18.0692 3.52162 +479 2 9.76751 5.80583 15.0218 -0.27339 26.7602 -8.06829 +480 2 9.98245 6.98264 13.9392 -2.96138 -9.43899 0.82382 +481 1 15.2804 4.29771 10.7711 -7.29951 -1.41697 -0.334277 +482 2 16.1821 4.02615 11.0218 -9.71269 11.8498 1.69675 +483 2 14.9105 4.9568 11.3864 17.8049 -7.45406 -3.59162 +484 1 11.2365 6.16159 0.180514 3.71779 6.92115 0.875598 +485 2 11.3264 5.36714 18.3195 14.2335 -18.3801 -6.22284 +486 2 10.2946 6.26806 0.197414 -17.1549 12.9032 2.71424 +487 1 0.0669242 11.3685 15.0652 13.212 -6.85086 18.3683 +488 2 18.0421 11.4114 14.3938 -11.7915 7.94746 -16.0964 +489 2 -0.126536 12.1197 15.6445 1.80559 0.362507 -3.06694 +490 1 7.04679 9.22841 7.26069 23.2883 20.8536 -5.26127 +491 2 6.49897 8.58869 7.67863 -15.4435 -25.8158 9.46312 +492 2 7.95399 8.89143 7.34084 -8.97527 1.37154 -2.4384 +493 1 18.3457 15.377 12.3544 -10.4554 -0.385944 -2.00928 +494 2 0.632165 15.4053 12.1583 18.2501 2.20759 0.366712 +495 2 17.9344 15.8751 11.6412 -4.56296 -0.981709 -1.73702 +496 1 16.5292 4.37759 5.24858 18.1125 19.5767 -27.8403 +497 2 16.7661 4.20984 6.14013 0.307987 -10.9951 33.7785 +498 2 17.3779 4.70209 4.86684 -19.0742 -11.8317 -4.1687 +499 1 17.7267 3.12899 10.7335 -24.2941 -12.2101 -5.28174 +500 2 18.5902 3.43151 10.9823 20.7538 0.196381 3.18907 +501 2 17.7917 2.2294 10.3565 4.74658 11.2046 4.02468 +502 1 12.2912 0.000462328 10.1205 5.29277 -42.3116 -12.7781 +503 2 11.463 0.345322 10.3908 -30.9755 9.64408 8.62664 +504 2 12.8898 0.704281 10.2182 28.9402 34.0259 3.93413 +505 1 10.3772 9.78855 12.3993 -21.9688 -12.411 -17.7787 +506 2 11.0129 9.78765 13.1014 16.013 1.76066 13.7043 +507 2 10.1738 8.8461 12.2399 4.72709 11.7982 0.616329 +508 1 0.569471 2.8284 7.02034 6.04311 -30.2491 -2.51113 +509 2 0.820763 3.41522 7.71636 2.48105 19.4463 13.5049 +510 2 0.862153 1.97327 7.38155 -6.15059 8.48947 -7.95665 +511 1 0.371359 15.3036 6.90441 -15.8595 21.8666 50.0789 +512 2 0.449232 14.6844 7.65301 -0.190166 17.9034 -2.10351 +513 2 0.621967 14.7945 6.18679 16.5003 -37.2512 -48.0182 +514 1 17.0414 7.00877 15.2159 -22.6634 4.89001 -1.64325 +515 2 17.7376 7.6544 15.0563 8.01654 -6.9456 2.15019 +516 2 17.4056 6.16817 15.5101 9.28872 0.897926 -1.45041 +517 1 9.06316 12.4266 8.08985 69.8766 6.47542 -0.0200154 +518 2 9.44101 11.8026 7.43298 -17.7999 4.13897 6.91255 +519 2 8.14431 12.4062 8.1331 -54.6706 -8.19385 -9.80298 +520 1 1.26891 1.85581 2.9921 11.7044 -8.67905 12.4997 +521 2 0.561231 2.0509 2.38915 -6.84046 11.4219 -12.1453 +522 2 1.65109 2.68456 3.32008 -5.2596 -5.54909 -2.36563 +523 1 4.11753 15.1048 9.79523 4.78264 -4.87511 12.6416 +524 2 3.99332 15.4569 8.91057 5.07926 -2.88804 -4.85995 +525 2 5.03278 14.7822 9.88586 -9.66079 5.58119 -5.37355 +526 1 7.25278 2.18203 14.6254 -0.555581 -14.0599 -5.06396 +527 2 7.1005 1.71681 13.7878 -2.90711 2.6098 7.34806 +528 2 7.71992 2.97108 14.3713 4.55177 12.8631 -2.10328 +529 1 18.557 14.6494 2.1729 -24.7771 22.3853 -4.36836 +530 2 0.778963 15.0461 2.09778 12.8139 1.02797 3.11036 +531 2 17.9275 15.4159 2.12338 10.4684 -24.8222 2.25012 +532 1 9.97282 2.76121 12.909 0.960373 12.9666 17.7509 +533 2 9.84581 2.0662 12.2717 -5.76657 -8.74665 -14.3806 +534 2 9.17654 3.31629 12.9308 6.08178 -3.78367 -5.74316 +535 1 2.89833 8.91803 13.044 14.9503 3.68581 0.826535 +536 2 3.29774 9.80788 12.9186 -7.17545 -13.4779 0.185991 +537 2 3.62224 8.34145 13.3619 -7.75262 8.46695 -4.72395 +538 1 3.21711 8.45664 3.69888 -1.45646 11.2765 -73.7917 +539 2 3.66926 9.20612 3.219 -10.9411 -20.3742 19.6072 +540 2 3.34915 8.55803 4.60102 11.7629 13.1896 57.1484 +541 1 5.60205 7.18882 8.56127 11.7766 6.17403 -13.6051 +542 2 5.73377 6.23122 8.60856 -5.21401 3.91262 5.39773 +543 2 5.15686 7.50265 9.34977 -6.87961 -7.75657 6.1504 +544 1 14.8989 1.38427 1.96946 -15.0866 25.6457 3.84218 +545 2 14.4906 2.19786 2.32837 7.96598 -16.9425 9.74227 +546 2 14.9786 1.62425 1.05302 13.5137 -6.97514 -15.0219 +547 1 8.3539 15.1902 0.828571 -0.607384 -15.7884 -3.69873 +548 2 9.11456 14.9295 1.35098 9.06641 9.90213 6.9538 +549 2 7.64957 14.6447 1.20074 -5.27592 0.575252 -4.39528 +550 1 15.5904 1.35118 7.21966 19.131 18.1941 14.0102 +551 2 15.0458 0.788774 6.70847 -19.486 -21.9805 -16.5491 +552 2 15.0172 2.08736 7.44992 -1.58717 6.06663 4.11757 +553 1 4.99095 13.0428 18.5017 -11.814 -5.03203 -22.7016 +554 2 5.38558 13.1981 0.699871 9.67176 2.40993 22.9792 +555 2 5.69857 13.2122 17.8695 -3.662 3.61759 -0.881885 +556 1 15.3616 8.52427 18.1264 -8.5134 -8.81723 23.808 +557 2 15.7284 8.98559 17.3934 10.1937 15.818 -24.0842 +558 2 15.2728 9.20414 0.16849 -1.83009 -5.75583 -0.912989 +559 1 12.0932 3.04939 18.3516 -14.5656 24.4873 8.42937 +560 2 12.4759 2.51827 0.417994 -2.38649 -9.33387 -9.98316 +561 2 12.2916 2.69447 17.4847 9.72648 -15.0074 2.48816 +562 1 13.2068 12.6815 5.17314 -7.19784 6.47098 -0.665029 +563 2 13.7108 11.8878 4.96601 4.53767 0.295949 3.70661 +564 2 13.3847 12.9363 6.09127 2.00425 -11.4311 -4.02895 +565 1 6.06883 7.14745 0.0914664 -7.81354 22.5487 2.98517 +566 2 5.88319 8.11419 0.19427 8.4279 -22.2037 -4.79949 +567 2 5.22519 6.72532 0.292473 3.10856 -0.243494 3.48057 +568 1 17.7194 15.9325 14.9871 -5.54638 -4.40987 -28.7902 +569 2 16.9069 16.4169 14.9498 -12.3977 10.2544 17.1316 +570 2 17.7594 15.7087 14.0393 19.0068 -3.79668 12.8095 +571 1 13.1727 0.977833 16.5926 -11.6444 6.00991 -1.45652 +572 2 14.0026 0.708875 16.9779 14.0624 -0.886732 -0.671765 +573 2 12.7076 0.152182 16.4397 -1.15444 -5.20647 -2.10321 +574 1 11.0384 14.6069 7.3103 -17.4066 -34.6271 2.52502 +575 2 10.2783 14.0261 7.58336 17.6612 20.778 -3.294 +576 2 11.8174 14.0391 7.44317 -4.14385 7.222 1.39489 +577 1 17.5379 8.55913 2.08836 4.35413 -11.6997 -13.5411 +578 2 16.664 8.39738 2.48219 7.20941 -2.48593 -6.20174 +579 2 17.6519 7.91106 1.34391 -7.20398 14.5397 25.454 +580 1 12.3635 7.91649 1.96817 14.6342 -23.934 -0.413214 +581 2 11.8532 8.69875 2.12901 -10.659 13.0689 -1.52352 +582 2 11.9409 7.3888 1.27378 0.548374 7.65925 3.61612 +583 1 11.9419 14.6308 10.3966 13.4402 32.5881 48.4479 +584 2 12.2905 14.0069 9.8182 12.9115 -34.2012 -37.3181 +585 2 11.0351 14.785 10.1903 -23.9611 0.860738 -9.13817 +586 1 6.84298 6.98317 15.5594 -28.1276 -29.1686 -18.0428 +587 2 7.705 6.91496 15.176 20.6419 5.27277 -3.3528 +588 2 6.85291 7.68491 16.1747 6.25697 23.8787 22.837 +589 1 8.01998 4.63032 13.4448 -35.0292 -26.7707 -36.5428 +590 2 7.42844 4.80515 12.6548 14.5268 -5.56395 32.2217 +591 2 8.43798 5.44118 13.6312 16.8653 30.885 3.99265 +592 1 13.3984 12.173 14.3104 -3.57217 10.7678 8.64565 +593 2 13.233 11.2355 14.1881 -1.19303 -4.98427 -3.70246 +594 2 13.8945 12.4998 13.5522 0.86121 -3.67781 -4.0367 +595 1 14.7231 9.47939 7.26845 -4.38272 9.59825 17.375 +596 2 15.5232 10.0108 7.49545 -18.3981 -9.5314 -3.88615 +597 2 14.0057 9.68134 7.91225 20.1628 1.06432 -13.939 +598 1 12.7179 16.9622 3.14627 23.4566 -37.2939 -10.6207 +599 2 12.9355 17.1415 4.04114 9.03221 7.6908 26.6047 +600 2 12.0213 17.5358 2.94483 -34.3001 33.1559 -14.5415 +601 1 1.10947 7.12267 17.419 -6.10821 -8.12856 16.9857 +602 2 0.178422 7.136 17.6887 4.23762 -2.5375 0.360706 +603 2 1.14096 7.54201 16.5672 -1.29203 8.00191 -14.7545 +604 1 12.8573 5.07319 15.6916 -26.4132 -0.426227 -0.347566 +605 2 13.5067 4.42508 15.4662 18.5417 -18.6841 0.103563 +606 2 13.3354 5.89586 15.6754 6.08426 15.3432 1.29959 +607 1 2.44451 3.37888 5.09109 -12.3042 -30.7639 -30.2825 +608 2 1.89914 3.20439 5.84354 -15.8924 -6.60657 16.2411 +609 2 2.9157 4.14854 5.30475 25.2943 38.046 11.4255 +610 1 8.30318 11.1757 13.537 -17.7368 31.3122 -83.5918 +611 2 8.23756 10.9827 14.4193 9.23305 -26.2584 72.471 +612 2 8.98641 10.7011 13.0548 11.9243 -7.18625 13.6047 +613 1 12.9121 1.44799 13.2982 3.17544 -30.959 19.595 +614 2 13.5829 1.31511 12.6431 13.7174 -5.57278 -14.8203 +615 2 12.5671 2.27513 13.0597 -18.9903 37.7092 -4.23536 +616 1 6.45025 13.6395 2.14169 21.7214 -12.6454 -10.4453 +617 2 5.88722 14.0323 2.78408 -20.3944 14.637 16.9787 +618 2 7.03563 13.0797 2.67163 0.317992 1.20831 -5.89746 +619 1 15.9341 6.54969 12.734 7.51439 18.2634 -8.82177 +620 2 16.366 7.12442 12.0552 -8.93517 -14.9663 18.1444 +621 2 16.3202 6.79095 13.5987 -1.79943 -6.04596 -11.4359 +622 1 16.8134 0.715269 9.59469 1.51011 24.5111 -1.75686 +623 2 16.9773 18.4324 9.6759 -2.99022 -25.9416 6.21625 +624 2 16.4855 0.841275 8.69831 -5.26956 1.43879 -3.58435 +625 1 6.14183 11.6821 8.34851 2.12045 33.7206 2.80541 +626 2 5.25373 11.5769 8.68031 -11.2997 -2.21294 6.8592 +627 2 6.41363 10.8186 8.10997 12.8023 -29.2169 -10.6172 +628 1 2.82878 8.69633 0.366162 65.7357 7.98524 25.914 +629 2 2.25196 8.1872 18.4995 -43.1364 -19.0897 -25.1642 +630 2 2.39827 9.3921 0.850531 -20.8372 5.7472 0.329713 +631 1 10.1125 10.4546 6.55694 -3.88563 -4.31924 12.8938 +632 2 10.5628 9.81084 7.11921 -1.26662 -0.776779 -0.718706 +633 2 10.7076 10.6109 5.83303 6.58413 -0.38446 -16.1853 +634 1 6.75197 15.7318 6.59922 10.1749 2.21511 -7.15796 +635 2 7.21229 16.0038 7.38721 0.121014 2.00215 12.9298 +636 2 7.17446 16.2736 5.9175 -9.12202 -3.23328 -2.5626 +637 1 6.44006 13.071 5.66115 9.01876 9.03356 -0.68679 +638 2 6.7952 13.9213 5.9766 -6.67057 -7.15315 -1.80184 +639 2 6.02558 12.6573 6.41982 -1.29087 -3.79345 3.79648 +640 1 16.7894 12.5351 9.7661 -6.01106 14.3853 23.3751 +641 2 16.9466 11.9627 9.02496 7.22561 -5.83165 -16.8213 +642 2 17.1452 13.4178 9.59292 -0.312151 -9.66884 -5.48162 +643 1 6.11103 2.94777 2.80745 -0.0522908 21.1759 -16.381 +644 2 6.20729 3.87808 2.49328 4.01665 -19.1858 15.5438 +645 2 5.82625 2.47942 2.01203 -2.73031 -5.31149 4.59086 +646 1 10.8562 3.22295 3.2592 5.83487 -6.01133 1.10343 +647 2 10.3184 3.99141 3.45824 -8.06424 0.347936 -1.44444 +648 2 10.5285 2.8344 2.43843 -2.26863 2.18612 2.83427 +ITEM: TIMESTEP +50 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.76267 6.9614 17.9655 18.039 1.32171 0.971735 +2 2 7.88851 7.04905 18.3237 -17.7355 -1.2272 4.07533 +3 2 8.77103 6.18416 17.4071 -1.73171 -4.43635 -4.46665 +4 1 18.7148 8.30367 6.79977 -11.0979 19.7573 -45.8218 +5 2 0.340011 8.13606 5.84126 -7.49685 -0.624375 38.3142 +6 2 0.514278 7.70743 7.38333 14.5888 -19.2797 9.57425 +7 1 8.47639 18.6969 6.83361 -13.2294 -1.25401 8.78355 +8 2 9.37315 0.218195 6.58559 19.0885 2.32763 -3.91705 +9 2 7.98208 0.748711 6.39478 -2.33131 3.58411 -1.86541 +10 1 6.52812 1.78346 11.693 -34.4751 -1.18092 9.20038 +11 2 5.67737 2.21709 12.0036 34.6116 -15.9045 -8.19534 +12 2 6.27488 0.856486 11.479 2.31906 19.7771 3.09659 +13 1 7.04596 5.66579 2.40189 46.2065 -42.3734 -14.42 +14 2 6.39782 6.00892 2.95716 -37.9245 28.3982 32.5204 +15 2 6.93615 6.04049 1.54428 -8.317 15.9019 -18.5798 +16 1 16.2302 10.236 16.0835 20.9593 -16.5275 2.4245 +17 2 17.1756 10.4542 16.2372 -23.2351 0.455296 -7.02457 +18 2 15.6872 10.9657 16.3738 0.757377 12.3052 3.78761 +19 1 10.6519 14.9414 2.32488 9.23959 14.6152 1.78567 +20 2 10.6414 14.4628 3.16471 0.797937 2.29677 -5.70575 +21 2 11.1604 15.7599 2.50148 -7.89724 -14.8548 -1.26363 +22 1 17.1653 8.24769 10.628 -7.00673 -3.15457 9.83212 +23 2 16.8168 8.85992 11.2947 -1.87186 0.196375 -6.64951 +24 2 17.9222 8.68524 10.2369 7.99899 3.60318 -1.68622 +25 1 14.7266 15.9157 16.4191 -13.8739 15.1565 -8.48964 +26 2 13.7936 16.2384 16.3951 24.1732 -8.40377 0.758561 +27 2 14.8582 15.5746 17.3097 -4.06225 -5.68183 -0.795501 +28 1 12.1165 13.3951 0.497647 12.4663 -12.7582 1.83308 +29 2 11.9617 13.3954 18.1814 -7.51799 5.11576 7.21512 +30 2 11.4424 13.8646 1.00511 -0.599491 5.86198 -7.65109 +31 1 9.3022 5.46358 3.98483 37.3 9.28522 -25.3544 +32 2 8.76176 5.25183 4.70521 -26.4917 -13.7331 37.3539 +33 2 8.69012 5.59126 3.27137 -14.2398 -0.31671 -15.324 +34 1 1.75646 4.13824 11.6126 7.13571 -34.631 6.10286 +35 2 1.57168 5.01735 11.8974 -3.49495 27.0073 7.26754 +36 2 2.15491 3.66767 12.3745 -6.50879 7.63382 -13.9832 +37 1 2.03017 6.80422 8.30837 9.29028 16.8447 12.8872 +38 2 2.52076 7.32809 8.97976 -10.1379 -7.93343 -11.4013 +39 2 1.79129 5.98703 8.76166 3.66627 -1.3648 -7.3534 +40 1 5.38278 4.45139 7.96045 1.48715 2.78745 -0.615366 +41 2 5.47525 3.53905 7.69237 2.73507 -15.0654 6.73754 +42 2 4.91072 4.84535 7.233 -11.388 9.54401 -10.9371 +43 1 3.30811 2.94776 17.4802 13.944 -42.282 -21.1312 +44 2 3.9986 3.21817 16.868 2.68053 3.29728 -0.298822 +45 2 3.01647 3.72731 17.8911 -19.397 34.8415 21.3069 +46 1 7.43048 5.35311 6.10326 -4.25319 -13.0158 -27.7806 +47 2 8.09022 5.89476 6.48364 23.034 26.3027 15.5228 +48 2 6.99872 4.97144 6.84559 -15.3695 -14.0963 19.964 +49 1 9.79676 7.01231 12.0156 -14.7328 3.59156 -15.7655 +50 2 10.3705 6.43202 11.4882 -9.23999 6.31012 5.56299 +51 2 9.04301 7.2927 11.4294 23.3546 -9.34629 13.9639 +52 1 14.0089 3.6286 8.06931 13.5755 5.11429 34.4728 +53 2 14.0074 4.36435 7.46412 -2.30693 7.62473 -7.33974 +54 2 14.3705 4.00595 8.91563 -10.4749 -13.1534 -24.8623 +55 1 4.55657 17.1558 3.95973 -9.28017 -24.3455 25.7085 +56 2 5.47914 17.3407 4.055 21.0307 11.7367 -4.03215 +57 2 4.1348 17.6911 3.31263 -3.95253 16.2794 -25.0192 +58 1 16.4751 16.614 10.2504 -32.3258 -7.85569 21.4695 +59 2 15.6275 16.6356 10.7813 29.977 2.99208 -16.9651 +60 2 16.2718 15.9944 9.53771 -1.01186 4.78751 -1.5712 +61 1 1.9619 4.81867 0.319959 -10.9755 -9.70287 -18.0846 +62 2 2.61752 5.08919 0.942567 15.1261 9.15008 18.4356 +63 2 1.74644 5.61951 -0.161427 -5.07436 5.04444 -4.19633 +64 1 11.5961 13.2841 16.3358 -4.45358 14.5896 10.2849 +65 2 11.0454 12.5131 16.3954 -10.7816 -16.1685 4.94665 +66 2 12.1536 13.1064 15.5876 11.3576 1.56581 -12.6168 +67 1 10.1325 11.0245 16.8746 -17.0839 37.329 0.881875 +68 2 10.5383 10.188 16.8005 14.1256 -36.2582 -1.95739 +69 2 9.19072 10.9065 16.7053 -0.138929 -3.60954 1.11764 +70 1 11.7656 17.449 13.475 -8.50487 25.248 2.18402 +71 2 12.3632 17.1066 12.8073 4.24528 -3.45864 -2.0733 +72 2 11.8231 18.4283 13.4081 4.57434 -16.4673 0.201387 +73 1 6.41878 9.35136 12.2283 -7.50229 14.2202 21.4939 +74 2 6.8057 8.89086 11.4896 12.6266 0.651555 -6.79619 +75 2 7.09031 9.88696 12.7035 -9.91308 -10.3657 -12.0835 +76 1 16.2619 12.8358 2.69678 7.42582 31.4023 -4.83963 +77 2 17.0939 13.3284 2.51069 -14.3032 -16.3414 4.28546 +78 2 15.5824 13.5473 2.68145 7.19887 -17.4175 4.43499 +79 1 0.698809 12.6212 5.89369 35.48 3.16674 13.5988 +80 2 0.938081 12.5288 4.97754 4.92149 -4.10163 -12.4931 +81 2 18.4194 12.7439 5.90006 -39.8609 3.63618 -4.1467 +82 1 5.237 16.4363 18.426 1.65878 -0.316472 9.22308 +83 2 5.81108 15.7548 18.0954 4.21498 -13.4949 -13.2329 +84 2 5.56972 16.5656 0.670239 -4.67124 7.34541 5.05152 +85 1 0.592121 7.69947 4.15467 -58.6061 -26.6762 36.9237 +86 2 18.6393 8.0928 3.5307 -12.7545 6.31849 -14.8448 +87 2 1.4218 7.85573 3.82511 72.6481 19.3185 -25.9209 +88 1 3.11983 8.96532 6.48794 54.6199 12.7003 -22.2767 +89 2 3.76913 8.45297 6.98254 -4.7725 1.8296 2.92636 +90 2 2.27977 8.75705 6.803 -46.0396 -12.4219 19.8369 +91 1 7.29807 10.3702 16.2638 20.6686 -0.114663 -24.6428 +92 2 6.66655 10.506 15.5642 -5.16108 2.7891 -5.34334 +93 2 6.78521 10.2638 17.0451 -10.3715 -1.64006 24.8745 +94 1 11.1174 0.987619 5.00277 -7.18116 3.53088 7.25248 +95 2 11.0089 1.86145 4.60844 7.25629 1.31859 -0.585836 +96 2 10.7387 0.391071 4.35918 -2.65397 -7.99376 -8.61355 +97 1 4.35641 2.82374 13.2083 -1.43301 42.1246 -29.6721 +98 2 4.74578 3.12447 14.0221 1.91906 -0.955597 13.0676 +99 2 4.17771 1.91012 13.264 -5.21231 -41.1093 14.0839 +100 1 8.41102 10.1748 1.81577 -7.29686 12.4487 -22.3398 +101 2 8.22152 10.8552 2.46036 0.4991 6.95458 5.373 +102 2 8.69583 9.43786 2.3232 10.7851 -24.1065 14.6426 +103 1 10.4306 1.70557 15.5491 18.4702 5.47966 -9.86629 +104 2 11.3921 1.67519 15.3716 -14.7227 -5.4908 8.94093 +105 2 10.0695 2.09393 14.7416 -3.28742 -2.92827 -1.64813 +106 1 2.67775 12.9037 7.82287 3.09642 7.69249 12.8714 +107 2 3.27779 13.5956 7.51776 -0.922255 -1.64886 -5.76029 +108 2 2.01429 12.7843 7.13996 -0.0248334 -2.64481 -5.98892 +109 1 3.74038 11.6511 5.07858 19.3958 17.4162 2.05128 +110 2 3.60589 10.7736 5.39333 -4.06789 -18.6575 13.0804 +111 2 3.07486 11.8033 4.42286 -17.2397 4.77378 -8.56343 +112 1 6.72135 14.4316 16.9296 11.8603 14.2358 -0.0778856 +113 2 7.64698 14.6853 17.0511 -5.38436 -3.23295 2.03342 +114 2 6.43726 14.8986 16.1349 -2.65892 -7.20284 -3.09426 +115 1 14.1884 14.544 3.35185 -21.8252 -0.368401 10.0779 +116 2 13.5247 15.1958 3.05461 14.5314 -4.887 4.26149 +117 2 13.7567 14.0734 4.09815 10.0173 4.52685 -16.1607 +118 1 8.41325 18.11 16.0503 -13.4237 14.7481 -2.40694 +119 2 9.01353 17.4146 16.1754 14.4883 -45.0972 12.851 +120 2 9.02228 0.139466 15.7926 3.66197 31.0187 -5.55304 +121 1 4.74026 1.68368 4.91774 -8.81747 -38.2992 48.653 +122 2 3.89365 2.07173 5.09257 -16.8489 9.86366 -0.181142 +123 2 5.05165 2.08173 4.1548 23.8621 30.7653 -48.3713 +124 1 15.012 12.6397 16.4637 21.182 -20.8114 -27.7575 +125 2 14.6363 13.1316 17.1743 -19.1608 12.2632 11.0748 +126 2 14.4002 12.4571 15.7145 4.23163 12.8017 20.733 +127 1 15.7141 18.464 16.8736 -48.8091 1.63943 -48.6642 +128 2 16.4537 18.5656 17.3974 52.451 1.55627 42.8989 +129 2 15.6088 17.527 16.6934 -4.99653 -8.13868 6.26406 +130 1 1.24245 1.19714 16.5568 -3.35795 -9.15112 -9.15157 +131 2 2.06126 1.67967 16.5955 12.2536 9.19 1.95012 +132 2 0.738255 1.56007 17.2754 -9.1343 5.49748 13.2621 +133 1 18.1403 4.48045 15.9024 -8.92064 9.41796 12.6958 +134 2 18.2534 3.91822 15.1507 3.10214 -9.7063 -13.7449 +135 2 0.333051 4.53253 16.3579 6.8431 0.540548 1.72555 +136 1 12.2576 16.9773 16.1451 24.3374 26.4028 -39.8206 +137 2 11.5235 16.7559 16.6626 -39.484 -19.8089 22.2101 +138 2 11.9275 17.1263 15.229 8.36672 -7.61232 16.8746 +139 1 16.0311 2.54163 18.1267 15.2184 -17.5558 18.8253 +140 2 15.6351 3.35325 18.4083 -9.02057 20.5203 4.48377 +141 2 15.9018 2.48695 17.1953 -7.32995 1.76863 -25.4669 +142 1 6.72575 13.8191 10.1968 -9.26978 -14.9128 -14.7006 +143 2 6.45064 13.4802 11.0509 2.35225 3.79258 9.11016 +144 2 6.47529 13.1065 9.58166 7.75573 8.69288 2.20437 +145 1 10.1667 18.3423 2.73278 -21.0918 -24.4685 17.5154 +146 2 10.3808 0.422697 2.17354 8.51297 19.7321 -20.8009 +147 2 9.25877 18.0911 2.47579 12.4496 3.13566 3.08398 +148 1 3.02618 17.7182 6.12046 9.12785 6.17449 -5.85825 +149 2 2.19895 17.4959 5.67953 0.482163 3.05546 -3.6427 +150 2 3.66706 17.9189 5.4073 -11.2068 -9.39986 11.0759 +151 1 12.5962 16.8879 7.98687 8.69067 0.386489 -7.96768 +152 2 11.911 16.2378 7.93697 -12.2796 -18.2514 -9.64148 +153 2 12.3467 17.3792 8.75804 4.49939 18.0195 12.184 +154 1 14.8895 15.2713 8.19847 3.78441 6.77747 -24.1674 +155 2 14.0908 15.8092 8.10802 0.530475 -1.70182 9.59272 +156 2 15.3507 15.4528 7.3473 -4.11878 -7.96121 22.2836 +157 1 17.7044 18.2264 0.345927 53.2191 22.2557 3.1655 +158 2 18.611 17.8064 0.306571 -34.334 1.581 -6.33561 +159 2 17.9464 0.534475 0.465882 -17.8927 -21.106 -0.514669 +160 1 0.816649 10.4426 1.34739 14.8692 48.9775 -23.6448 +161 2 0.0612409 10.0129 1.68761 -29.4632 -23.0248 11.5333 +162 2 0.465717 11.2339 0.843051 15.2672 -28.7963 15.4324 +163 1 1.72991 12.2406 3.39174 -15.9976 -2.88445 -44.3457 +164 2 1.42407 11.5936 2.70825 8.45982 5.87631 22.8389 +165 2 1.72198 13.0652 2.87637 5.68226 -3.3333 12.0496 +166 1 0.611993 17.231 4.90821 -34.3512 10.3394 53.8078 +167 2 18.7649 18.0776 4.93361 14.0145 -8.94618 -14.8948 +168 2 0.320128 16.8659 5.79609 20.9887 -2.41003 -36.5782 +169 1 1.10304 0.897417 9.42158 -11.0752 -12.4205 -5.86027 +170 2 1.33193 0.471936 10.271 -7.8206 6.77035 -10.9921 +171 2 0.260273 0.49253 9.11811 18.1645 10.0729 11.6017 +172 1 16.7431 2.34345 13.2996 -3.12231 -7.25082 27.0749 +173 2 16.9139 2.55723 12.403 6.00909 8.65593 -29.5603 +174 2 16.479 1.41627 13.3001 1.0866 -1.80785 3.13205 +175 1 2.64585 15.864 12.1283 -21.2463 14.7527 -7.08654 +176 2 3.15605 15.3934 12.7599 11.6364 -10.3414 18.5671 +177 2 3.00262 15.6045 11.2815 4.79088 -2.17896 -11.8296 +178 1 16.4298 15.6598 6.07287 -23.7839 -45.9221 18.6798 +179 2 17.316 15.6562 6.39936 21.0579 5.20152 4.08476 +180 2 16.3078 16.3335 5.44341 2.1367 33.4546 -25.3893 +181 1 5.80337 5.0927 11.7988 -16.1764 10.2154 8.68093 +182 2 5.24436 5.75105 12.277 17.1169 -11.9851 -7.24057 +183 2 5.28663 4.27668 11.796 1.81497 4.13117 2.00496 +184 1 15.1635 4.86687 0.779797 10.276 15.6296 -42.8981 +185 2 15.0374 4.47718 1.61189 -4.55383 -15.7546 43.9488 +186 2 14.356 5.34586 0.597493 -2.57536 1.02491 -2.93315 +187 1 16.3458 16.3763 2.04771 3.47576 3.66541 23.8501 +188 2 16.2044 16.7006 2.97252 -3.72753 -7.68524 -25.3267 +189 2 16.7389 17.1226 1.58867 -0.552753 3.82143 -4.99822 +190 1 0.255881 4.83863 3.82235 -11.3764 -61.9515 -5.66134 +191 2 0.347221 5.7447 3.93716 8.7619 60.1171 8.48532 +192 2 0.834328 4.39842 4.45398 2.37129 4.71095 -1.99834 +193 1 2.9563 15.0569 15.1257 1.71124 8.82343 -41.1566 +194 2 2.85861 14.8634 16.033 -5.32392 -14.5435 34.6784 +195 2 2.48389 15.8911 15.0234 3.12674 0.885842 0.387353 +196 1 1.13777 14.6522 9.5263 -30.3315 0.106042 24.0606 +197 2 1.89024 14.3075 9.07024 17.4708 -15.5826 -4.95385 +198 2 0.933623 14.0402 10.2733 8.29602 9.54759 -23.1661 +199 1 13.5292 16.584 11.5416 25.6454 -21.6132 21.0377 +200 2 13.328 17.2834 10.9465 -13.4726 19.9213 -18.5602 +201 2 13.2496 15.765 11.1158 -9.99742 3.11837 -0.28929 +202 1 4.66126 1.44669 0.76776 24.0608 13.759 -10.2694 +203 2 4.19513 2.00271 0.14116 -5.95148 5.85957 -2.67997 +204 2 4.06121 0.755814 1.00952 -11.6339 -11.0076 11.757 +205 1 1.46276 18.5641 11.8468 9.16484 -20.9655 21.4802 +206 2 1.29795 0.448688 12.6433 2.09315 -1.75191 -4.75625 +207 2 1.84947 17.7191 12.1761 -6.39306 18.521 -9.12508 +208 1 11.4915 10.1299 3.99438 -29.0311 -19.3551 44.8744 +209 2 11.2201 10.4871 3.17848 -8.25775 15.5063 -35.6965 +210 2 12.4189 10.233 4.02648 37.0944 1.09916 3.99775 +211 1 8.27499 12.1796 3.66337 18.6814 -7.12196 -36.2468 +212 2 9.0689 12.5922 3.98877 11.875 7.24467 3.22649 +213 2 7.6764 12.2152 4.36849 -32.1167 2.17346 40.1921 +214 1 14.4874 4.01368 3.28039 -17.5005 -0.0616197 -21.9184 +215 2 14.9648 3.93911 4.08552 21.5727 -0.139675 21.9436 +216 2 13.7566 4.60071 3.48465 -5.84393 1.34015 1.64127 +217 1 5.62374 1.66322 7.51635 70.0554 58.4457 -44.6253 +218 2 5.02312 1.16941 7.9611 -67.4835 -53.4064 45.1295 +219 2 5.39821 1.60037 6.57846 0.425083 -1.20148 0.902483 +220 1 17.8844 1.0604 4.85627 -10.0966 -7.93422 8.12116 +221 2 18.57 1.49808 4.37578 15.6561 4.82809 -15.3219 +222 2 17.6975 1.64814 5.58583 -4.12013 1.11537 7.77052 +223 1 6.80576 9.4106 4.49942 14.9318 -4.14838 16.3077 +224 2 6.92469 9.61899 5.44741 -8.81338 -3.93454 -14.2946 +225 2 7.68422 9.10473 4.22333 -4.88591 1.73472 -0.668879 +226 1 2.61188 14.876 1.98504 -6.91902 -4.93882 19.1315 +227 2 3.25848 14.7083 2.68056 -2.68924 0.660774 0.84214 +228 2 3.12462 14.9058 1.19269 5.2127 1.18228 -19.2613 +229 1 17.303 12.9246 13.1525 10.3788 -12.5807 -3.95397 +230 2 16.4389 13.2985 13.3385 -0.36563 10.0164 -0.276732 +231 2 17.9169 13.6449 12.9311 -14.7092 -1.11942 1.9762 +232 1 14.9246 10.553 1.38722 24.8563 30.4026 18.8772 +233 2 15.5245 11.2788 1.76222 -27.4309 -28.2887 -15.3922 +234 2 14.0162 10.8271 1.54897 4.06804 -0.689498 -1.36825 +235 1 5.72717 6.70809 4.58418 -6.56467 23.581 -8.85087 +236 2 6.06385 7.62371 4.66236 -8.01259 -10.4186 -5.73866 +237 2 6.2767 6.1943 5.16785 8.48743 -6.29877 6.22452 +238 1 8.0009 8.33508 10.3687 14.1913 1.83663 -35.3126 +239 2 8.52082 9.13006 10.161 -0.0651459 -5.63876 7.89795 +240 2 7.94932 7.91253 9.48819 -6.75295 -2.00865 18.056 +241 1 13.4409 18.4268 5.72382 16.6357 0.722738 -15.7997 +242 2 12.6296 0.221713 5.47389 -5.04693 11.9449 -2.85301 +243 2 13.1936 17.8965 6.46343 -5.47963 -14.8645 21.1785 +244 1 0.0859293 2.63743 0.236192 -9.12202 -35.143 -2.56963 +245 2 17.9325 2.9505 -0.168165 -24.3821 -4.07692 -4.34214 +246 2 0.590564 3.4143 0.297916 33.333 32.0117 7.87133 +247 1 12.8395 11.0444 9.74231 45.1743 -31.9509 26.4779 +248 2 11.9686 11.0602 9.42407 -43.5447 -1.91263 -10.9888 +249 2 12.9558 10.1388 10.1456 -3.41612 23.6256 -14.6869 +250 1 0.710059 12.1592 11.0756 -10.531 -0.362272 -11.4251 +251 2 18.3753 12.1255 11.106 13.0957 4.94421 7.25875 +252 2 1.07349 12.4339 11.9177 -3.83141 1.58371 11.017 +253 1 5.10203 7.3136 13.4291 15.7719 5.5957 -0.396148 +254 2 5.6162 7.93373 12.8769 -6.75271 -3.40235 8.70115 +255 2 5.62723 7.25347 14.2483 -7.64248 -3.9813 -9.01905 +256 1 1.21129 6.85545 11.8946 29.9494 36.4661 12.0403 +257 2 0.485742 7.25442 11.415 -4.88796 -0.516932 -2.56673 +258 2 1.80546 7.64481 12.127 -26.2797 -36.2571 -7.59378 +259 1 15.5076 9.61367 12.3051 21.7085 -42.1446 -13.9552 +260 2 15.1772 10.4675 12.1584 -16.5272 42.565 -1.064 +261 2 15.3545 9.37182 13.2055 -3.21788 1.51701 18.7315 +262 1 16.6116 12.7513 5.5295 7.16384 -7.58562 22.1279 +263 2 16.3878 13.6701 5.61583 -3.61437 18.1746 3.54477 +264 2 16.4616 12.5615 4.61757 -3.38991 -5.42355 -25.0954 +265 1 6.3014 9.86096 0.0280098 12.3864 1.00447 14.78 +266 2 5.6246 10.4136 0.42972 -1.13337 -0.2267 2.50286 +267 2 7.03571 9.82087 0.686012 -15.2579 5.10695 -14.0237 +268 1 12.3034 6.12839 4.06739 18.1147 15.8957 -28.6536 +269 2 12.3348 6.66771 3.23063 -4.28261 -10.1618 29.3394 +270 2 11.5855 5.52112 3.9529 -14.8183 -8.35162 -1.01689 +271 1 0.289245 12.8118 0.17396 1.00074 4.7721 1.62068 +272 2 0.031574 13.4709 0.828681 0.933398 1.09562 1.96647 +273 2 18.4473 13.0492 18.0252 -3.3255 1.79332 -7.06642 +274 1 3.67377 18.6092 8.59256 -12.2718 12.3972 8.90671 +275 2 3.51633 18.2244 7.72678 0.0355868 -3.61867 -2.60117 +276 2 2.80982 0.36536 8.82196 13.0622 -5.69839 -0.636093 +277 1 7.44701 17.3263 4.47819 -12.2479 -42.1382 8.27198 +278 2 7.47198 18.2285 4.71954 7.46065 34.1282 3.2472 +279 2 7.59543 17.2523 3.54279 -0.328999 6.68987 -14.4609 +280 1 9.24493 17.1077 12.2387 -39.9724 15.9122 -7.56371 +281 2 9.27102 16.3677 11.6468 4.90539 -16.8252 -9.88175 +282 2 10.091 17.2207 12.6154 35.0883 -2.17581 15.9571 +283 1 13.2831 12.983 8.01599 31.7457 23.9761 -1.258 +284 2 13.3856 12.1913 8.53584 -3.88389 -9.78552 5.15809 +285 2 14.1414 13.4672 8.16531 -29.1617 -3.59582 -8.01118 +286 1 14.8948 2.98524 15.3712 -17.5751 0.764594 21.5491 +287 2 14.1876 2.34218 15.2724 -1.25262 -5.58382 2.64656 +288 2 15.4061 2.89645 14.5861 17.2961 2.13088 -20.5882 +289 1 9.89537 15.5662 16.9902 -4.09035 4.17693 9.89685 +290 2 10.2983 14.7234 16.7502 5.73332 1.10161 -2.59445 +291 2 9.67249 15.5035 17.9343 -2.60097 -1.56266 -9.87078 +292 1 11.3274 8.38795 16.5853 -21.4847 -13.5698 4.02619 +293 2 10.6433 7.93033 16.0536 12.1725 7.69909 5.41873 +294 2 11.2563 7.95351 17.4557 6.17465 6.37506 -11.4872 +295 1 3.9593 18.2162 16.7697 0.697619 -14.1615 -14.1273 +296 2 4.40283 17.477 17.2226 -3.01571 14.2153 3.03122 +297 2 3.77495 0.26362 17.3949 3.98021 5.349 11.1126 +298 1 2.22376 4.19593 8.92134 -23.2189 1.10906 -21.9008 +299 2 3.13693 4.25168 8.71451 27.6214 0.869066 -8.80864 +300 2 2.192 4.13003 9.85498 -3.77747 -6.53541 33.4183 +301 1 9.87956 10.3806 9.72418 15.1316 -34.7661 11.7533 +302 2 9.43202 11.1334 9.41625 -17.3542 37.4051 -17.5479 +303 2 10.0318 10.5223 10.6578 4.66737 -1.93825 10.7585 +304 1 9.70627 0.903434 10.8708 -16.6391 -17.8124 -8.64764 +305 2 9.32253 0.0380009 11.0933 9.22807 5.63208 7.52542 +306 2 9.08638 1.2149 10.1967 9.10725 8.78511 -0.274781 +307 1 9.19757 15.1031 10.2247 30.2853 16.2782 3.75492 +308 2 8.7691 15.7671 9.69642 -6.57671 14.9232 -6.79792 +309 2 8.58248 14.3993 10.2376 -24.9838 -23.9988 3.33467 +310 1 0.938497 9.56303 10.2766 -19.6808 1.12411 10.869 +311 2 0.864208 10.4264 10.69 -4.58503 2.29603 -0.877129 +312 2 1.8082 9.5891 9.92621 21.6362 -6.44505 -13.6115 +313 1 17.0002 4.85339 8.15215 21.2107 4.17599 -32.9154 +314 2 16.5226 5.60356 8.44909 -16.9553 23.1583 5.35412 +315 2 16.856 4.21761 8.81327 -1.81027 -27.4365 28.1652 +316 1 14.7301 14.7112 0.178334 14.6842 0.804622 -15.2869 +317 2 15.1474 15.2511 0.844024 6.42123 6.45952 11.8737 +318 2 13.9865 14.3021 0.591484 -20.7841 -7.92944 9.37323 +319 1 3.69091 11.0487 9.53568 5.98335 -8.96355 13.8332 +320 2 3.56651 11.2839 10.4631 4.16949 4.48414 3.3219 +321 2 3.23005 11.7193 9.04032 -8.2098 7.45463 -11.8198 +322 1 11.2005 10.7579 1.45634 -8.62161 -19.8695 4.90197 +323 2 11.5404 11.5862 1.17391 12.694 26.4047 -12.3165 +324 2 10.2904 10.7467 1.15081 -4.44873 -2.97897 0.910453 +325 1 13.1494 7.14877 12.735 25.4211 -2.46103 0.847156 +326 2 14.1287 7.02261 12.7655 -19.3043 2.68773 1.11168 +327 2 12.7806 6.27183 12.8763 -3.1166 -1.04351 -1.25783 +328 1 9.62343 1.89491 0.979311 -12.9604 6.63616 -29.4885 +329 2 8.7946 1.64267 0.49669 19.6199 4.62861 14.6045 +330 2 10.1494 2.42868 0.345455 -5.12075 -11.8177 11.3147 +331 1 10.6335 13.514 4.5646 -17.0056 -0.486025 -1.57099 +332 2 11.3585 12.913 4.68456 17.6411 -7.84828 -0.965736 +333 2 10.6299 14.042 5.36013 -0.769181 5.74096 10.189 +334 1 14.4133 1.73933 10.9414 -11.8391 -17.207 6.29742 +335 2 15.2077 1.35218 10.5638 5.14778 2.73806 -3.87278 +336 2 14.5015 2.69292 10.9149 5.22965 5.71868 -2.86675 +337 1 14.5722 12.1975 11.686 14.094 -1.05888 37.2495 +338 2 15.3017 12.3928 11.129 31.2021 7.92611 -10.369 +339 2 13.8916 12.0994 11.0714 -43.9062 -9.54665 -27.6985 +340 1 8.20779 5.06885 9.81189 17.2837 -27.279 -13.9945 +341 2 7.476 5.2926 10.3565 -21.7486 9.79802 13.7153 +342 2 8.11585 4.0945 9.69767 5.61634 21.6585 -4.44102 +343 1 1.51211 16.8659 18.4077 -7.21278 -21.5738 6.32543 +344 2 1.92778 17.2486 17.641 3.99023 3.9685 -12.2343 +345 2 1.4425 15.9033 18.1995 7.9863 23.2313 7.90302 +346 1 1.50475 17.27 15.3217 -52.6385 22.4638 18.049 +347 2 1.49283 18.1952 15.6793 7.67726 -26.1665 -10.1971 +348 2 0.544177 16.9836 15.4083 37.5739 4.67989 -9.3974 +349 1 3.64958 5.72975 6.08508 6.29069 -26.5723 -11.3796 +350 2 3.20343 6.25343 6.73323 -12.457 15.9806 12.721 +351 2 4.14586 6.29176 5.4852 3.70859 6.95385 1.18178 +352 1 12.4272 9.46789 14.1967 -22.2867 60.9428 4.59069 +353 2 12.8141 8.72569 13.8244 25.5413 -52.6107 -24.0302 +354 2 12.2248 9.22264 15.0865 -2.36671 -8.29514 20.866 +355 1 4.05215 15.2773 6.93811 -37.3363 -16.6714 15.1212 +356 2 3.52112 16.0418 6.69595 1.88806 4.21981 -3.16255 +357 2 4.93922 15.5036 6.7631 37.0693 10.9568 -7.31607 +358 1 0.634621 8.6113 14.9988 -1.00168 -8.57623 6.03626 +359 2 0.426563 9.53409 15.1284 -0.450123 11.8509 1.14186 +360 2 1.36493 8.60238 14.3834 7.02364 0.17651 -8.78598 +361 1 12.9488 8.28918 10.2591 -12.3232 2.05195 12.3522 +362 2 13.6164 7.77926 9.80228 8.67745 -2.84232 -3.45719 +363 2 12.9296 7.914 11.161 -0.920073 6.75149 -12.343 +364 1 15.3287 7.72887 3.53701 30.7324 40.0945 -27.1654 +365 2 14.5687 7.40616 3.08394 -23.025 -16.3354 4.19175 +366 2 15.5452 7.39964 4.39595 -10.5646 -17.2283 18.769 +367 1 17.3078 6.69366 0.0430756 19.9915 -9.88107 5.38445 +368 2 16.7705 5.94464 0.294276 -4.0765 -7.9871 3.32428 +369 2 16.6874 7.33606 18.3865 -21.7939 19.8828 -6.94939 +370 1 8.91017 6.93043 7.77699 23.4025 28.7729 -7.70378 +371 2 9.81824 7.33337 7.84479 -23.824 -15.1706 -1.9244 +372 2 8.86104 6.22236 8.40836 -0.772968 -13.4081 16.1446 +373 1 12.3843 0.611213 1.25908 1.98263 -0.697807 -4.79042 +374 2 13.323 0.393307 1.31761 -0.925839 8.32556 5.35041 +375 2 12.1237 0.465738 0.350227 -1.33982 -4.5367 -2.71568 +376 1 5.61465 15.1448 14.5392 -1.26631 -30.1046 6.25467 +377 2 4.66418 15.2406 14.6702 -0.2102 4.52428 0.84195 +378 2 5.97383 15.921 14.1393 5.11494 24.4221 -7.05072 +379 1 3.84895 6.44034 1.72963 2.7696 -8.11358 7.79979 +380 2 3.51864 7.3032 1.48291 -7.06055 11.1725 -5.60147 +381 2 3.99368 6.51729 2.68239 -0.0521329 1.22822 -5.4234 +382 1 3.90083 11.5778 12.3664 -12.9911 -8.32668 -3.5509 +383 2 4.78352 11.9371 12.4749 4.25232 1.56379 3.39016 +384 2 3.29545 12.1182 12.8978 7.28302 -2.19426 -6.07273 +385 1 5.34262 3.87885 15.873 -6.15348 -82.0204 -11.7996 +386 2 6.0076 3.23261 15.5032 -15.8888 19.1459 15.4213 +387 2 5.69117 4.71679 15.7838 27.5644 60.3601 -6.10452 +388 1 14.3156 10.2471 4.51115 -35.9806 40.7967 42.7391 +389 2 14.5125 9.92103 5.39777 -3.50802 -2.54983 -0.445713 +390 2 14.828 9.75135 3.94137 33.3968 -38.7315 -40.7643 +391 1 7.75287 17.3919 9.13705 13.5919 -13.2315 -4.02741 +392 2 6.89819 17.6363 9.44363 -21.9658 0.853712 16.3055 +393 2 7.88604 17.9611 8.38483 9.7933 6.77297 -11.9047 +394 1 4.50916 14.5069 3.91348 -1.14645 -26.1805 -53.139 +395 2 4.48781 15.3883 4.18695 -0.715057 47.311 12.47 +396 2 4.59583 14.0061 4.68593 4.03467 -28.7439 39.2156 +397 1 14.2649 7.40032 15.8248 -22.801 -12.9293 -21.4811 +398 2 15.1988 7.32934 15.7188 25.9215 -1.64325 -3.33443 +399 2 14.1282 7.83404 16.6492 -0.714938 9.98648 22.5393 +400 1 3.02257 18.338 1.93829 -9.63799 -32.7056 -36.1055 +401 2 2.55646 17.7535 1.2554 15.187 19.9859 31.9951 +402 2 2.37728 0.279403 2.32429 -11.6166 9.08866 3.80637 +403 1 7.9856 1.63208 4.58686 -21.2194 7.37107 -10.8429 +404 2 7.46714 2.08087 3.89599 -2.9365 -3.17783 11.7342 +405 2 8.82293 1.5175 4.16848 19.7493 -4.53145 -2.81354 +406 1 2.46603 14.1528 17.6814 26.4379 24.7021 -16.3984 +407 2 1.84119 13.6421 18.1459 -27.3849 -25.1212 16.5566 +408 2 3.3203 13.7773 17.9154 6.17156 -2.74614 2.81365 +409 1 0.847673 1.77812 13.8995 -29.1857 4.71799 7.40329 +410 2 0.70153 1.57851 14.8469 9.71331 1.1605 -15.3576 +411 2 18.5888 1.96886 13.5517 20.2657 -3.94578 7.10705 +412 1 4.44078 18.6823 13.9019 -16.0244 4.84661 7.61196 +413 2 5.30649 18.3093 13.8135 20.8517 -5.19628 -2.25594 +414 2 4.21344 18.5423 14.8331 -2.2181 0.553195 -4.50589 +415 1 7.17333 0.707602 18.3659 18.5924 -14.7376 -19.2949 +416 2 7.29313 0.222373 17.5065 -5.17699 16.3575 23.4569 +417 2 6.28409 1.05221 18.4099 -11.4153 -0.902781 0.0516699 +418 1 16.0458 18.3995 13.9929 19.922 2.02833 15.0786 +419 2 15.1358 18.307 13.8248 -34.099 -5.52537 -15.9309 +420 2 16.0494 18.5146 14.948 8.19193 5.7614 4.60276 +421 1 10.1078 4.56818 16.2539 38.806 25.935 -8.65561 +422 2 11.0636 4.83663 16.0361 -35.078 -16.4147 14.4025 +423 2 10.0818 3.61692 16.3176 2.43484 -11.3153 -3.34335 +424 1 15.9163 17.7591 4.46968 32.0074 -29.6155 -15.1132 +425 2 16.5099 -0.143617 4.50341 7.95185 14.4383 0.237761 +426 2 15.1003 18.0575 4.79025 -43.3278 16.7712 13.4837 +427 1 7.00774 17.4246 13.8321 -56.0949 -7.97771 -22.4327 +428 2 7.49162 17.6994 14.5684 25.5375 13.311 41.1471 +429 2 7.64463 17.2266 13.1734 23.6351 -3.93018 -21.4132 +430 1 13.2756 6.47326 6.61789 23.4956 20.1255 -14.8261 +431 2 14.0898 6.99784 6.40679 -18.3755 -16.6425 15.9473 +432 2 12.9103 6.33261 5.73881 -7.54238 -3.20295 2.17295 +433 1 7.79764 2.32743 9.30513 0.620653 -0.611916 41.3127 +434 2 7.26457 2.16571 10.1169 11.5422 6.28076 -11.6799 +435 2 7.22158 2.07024 8.60986 -14.5852 -6.72752 -26.4814 +436 1 15.1722 14.8472 13.687 6.75051 -12.1688 -2.41191 +437 2 14.9232 15.197 14.5358 -2.94711 1.82763 14.9216 +438 2 14.8185 15.4404 13.0388 -8.36185 8.62669 -11.0165 +439 1 9.38377 8.31795 3.7734 -21.5197 15.3047 -10.1967 +440 2 10.1883 8.66352 4.14356 14.5642 4.86611 3.27566 +441 2 9.4002 7.3753 3.8765 5.94621 -16.0238 5.03493 +442 1 17.77 13.5913 16.4331 -7.58631 -31.5789 18.0626 +443 2 16.8485 13.2919 16.3991 0.887673 4.05725 -0.920823 +444 2 17.783 14.4232 15.9937 -0.095827 22.773 -14.6224 +445 1 4.93053 10.5741 2.80353 -17.5831 18.6377 -10.1976 +446 2 5.6584 10.2884 3.33403 15.5926 -12.1878 10.3648 +447 2 4.56303 11.3186 3.30761 3.36544 -9.45409 -4.10473 +448 1 3.72361 8.36764 10.1215 3.29328 14.9495 -8.98506 +449 2 3.89363 9.29817 9.8724 -2.16289 -13.6958 -0.787578 +450 2 3.61222 8.39575 11.0685 -3.0862 -1.08413 10.2171 +451 1 15.9739 6.97387 6.06952 -13.2047 20.7109 0.201327 +452 2 16.7663 7.43242 6.33309 11.9845 5.69104 3.28059 +453 2 16.2425 6.10629 5.81378 6.71976 -25.6546 -0.898294 +454 1 15.1226 7.10933 9.08497 -8.54326 -39.6564 44.8588 +455 2 15.7377 7.52152 9.6861 12.0306 8.12876 4.18876 +456 2 15.1451 7.58697 8.30383 2.04885 32.3579 -51.8464 +457 1 6.29947 12.9646 12.7695 3.37722 -4.66482 -6.66232 +458 2 7.17165 12.6249 12.9809 1.24175 -10.0492 1.61343 +459 2 6.12977 13.6114 13.4445 -6.34808 15.4581 9.54933 +460 1 12.1164 4.51054 13.0962 -37.6646 -34.1548 1.17408 +461 2 12.2607 4.59773 14.0409 7.03003 6.16295 4.50476 +462 2 11.318 3.89029 13.036 30.5495 29.2935 -6.64922 +463 1 11.3767 8.15056 7.89733 -18.501 8.72492 -14.0328 +464 2 11.9999 7.57003 7.45959 11.3303 -6.40222 -0.944592 +465 2 11.6722 8.28384 8.79215 9.56916 -2.23029 14.0742 +466 1 17.1624 10.8628 7.5038 -34.939 16.2827 29.0255 +467 2 17.7665 10.1757 7.31962 29.6392 -23.074 -13.6235 +468 2 17.1223 11.4937 6.79065 1.17945 1.22203 -15.4432 +469 1 5.28569 18.1322 10.989 31.979 0.201705 -2.44437 +470 2 4.81806 17.865 11.7612 -14.4656 -7.34411 17.8618 +471 2 4.63582 18.2948 10.3295 -20.6991 2.34913 -21.9288 +472 1 7.59755 17.5197 1.78957 -4.56355 -5.70379 -23.6831 +473 2 7.90081 16.7255 1.29504 -6.23989 15.492 10.1621 +474 2 7.18064 18.108 1.12072 15.1074 -6.58967 11.1205 +475 1 1.93009 12.8809 13.5782 -3.15102 -7.76664 -18.9393 +476 2 1.45787 12.3423 14.2065 -6.90584 -5.9659 9.51664 +477 2 2.19823 13.666 14.0335 5.43227 17.0545 14.7464 +478 1 9.58089 6.76558 14.8178 3.72821 -35.8509 -10.9213 +479 2 9.75861 5.80832 15.0417 -6.66727 32.4051 0.0155959 +480 2 9.77461 6.83059 13.8656 0.408011 6.2359 8.07479 +481 1 15.2957 4.27102 10.7659 9.27088 14.9202 31.1326 +482 2 16.1322 3.95288 11.1528 -7.49935 1.06904 -21.0932 +483 2 15.0846 4.9939 11.387 -3.9034 -8.13187 -14.3813 +484 1 11.2455 6.18064 0.162868 26.0255 26.7031 14.5737 +485 2 11.4763 5.37121 18.3763 -4.81733 -21.4086 -8.3593 +486 2 10.308 6.3098 0.211594 -20.2553 -5.22819 -8.60243 +487 1 0.00824002 11.3791 15.0352 26.3856 -8.14992 32.1511 +488 2 18.096 11.5216 14.3022 -25.0888 8.62779 -34.0528 +489 2 -0.201285 12.127 15.606 2.8625 2.75044 1.90901 +490 1 7.02689 9.25213 7.27678 19.2929 16.5016 -4.78745 +491 2 6.59278 8.51389 7.67295 -14.5933 -20.8184 8.5158 +492 2 7.9603 9.00351 7.26624 -3.73747 1.30273 -1.02295 +493 1 18.3276 15.3446 12.3362 -3.78489 -4.33158 3.75643 +494 2 0.608087 15.5074 12.1532 11.0792 5.95639 -3.98767 +495 2 17.812 15.8736 11.72 0.968766 1.6464 -4.64437 +496 1 16.5183 4.40219 5.2766 -9.25512 24.5768 -59.2644 +497 2 16.7942 3.98653 6.05327 18.9035 -16.7679 44.3388 +498 2 17.2936 4.55111 4.6869 -10.7937 -7.24122 14.527 +499 1 17.7074 3.16435 10.7411 -7.07567 -19.8863 -1.17515 +500 2 18.5775 3.40914 11.0222 18.8337 10.6004 6.41913 +501 2 17.8312 2.27039 10.3862 -7.09349 4.4518 -2.20884 +502 1 12.3002 -0.0151335 10.1074 11.0606 -47.8945 -14.4391 +503 2 11.4203 0.251866 10.2671 -34.8312 14.3717 9.25421 +504 2 12.8296 0.729107 10.2725 26.3435 36.9272 6.71278 +505 1 10.377 9.78 12.4264 -19.0889 -11.9366 -11.7107 +506 2 11.0349 9.79085 13.1125 14.2042 0.527855 9.4859 +507 2 10.1856 8.83311 12.286 4.63513 11.4958 0.11243 +508 1 0.612468 2.80552 7.03105 -3.16196 -18.6605 -12.6623 +509 2 0.888173 3.44011 7.68312 3.89236 7.11247 14.3448 +510 2 0.935234 1.94488 7.34043 -2.08916 10.0979 2.30791 +511 1 0.333274 15.3197 6.88029 -14.1577 45.9776 55.0939 +512 2 0.45846 14.8119 7.69617 1.50982 5.91417 -3.14315 +513 2 0.483825 14.7581 6.18064 16.8578 -51.3136 -47.9608 +514 1 17.0479 7.0004 15.1603 7.32733 3.15391 4.0553 +515 2 17.7743 7.62519 15.0492 -4.65368 3.90748 -3.79045 +516 2 17.4843 6.26113 15.5911 -6.30626 -9.6282 -1.63315 +517 1 9.09335 12.4409 8.06571 39.5186 -12.5139 -7.54936 +518 2 9.34597 11.7249 7.45783 10.9221 9.9246 5.15013 +519 2 8.17581 12.4072 7.99758 -53.4732 7.6014 3.58329 +520 1 1.26136 1.81045 2.95361 -2.6705 2.40839 8.80735 +521 2 0.548126 2.01955 2.35817 -5.69651 1.92544 -13.4687 +522 2 1.50342 2.66138 3.33407 8.35517 -3.762 3.05283 +523 1 4.10861 15.1005 9.87028 17.6559 -3.6711 -5.25272 +524 2 3.99986 15.4157 8.96812 -4.49733 0.314881 -1.79245 +525 2 5.04559 14.8362 9.90181 -11.0653 1.71965 6.05025 +526 1 7.3044 2.18074 14.6544 -4.4599 -5.38687 1.90914 +527 2 7.13921 1.65822 13.8561 -1.41133 5.62984 3.30149 +528 2 7.58548 3.05039 14.3636 5.58134 3.87352 -5.39735 +529 1 18.5311 14.6245 2.16796 -28.4168 7.73599 -0.688338 +530 2 0.75601 15.0339 2.21782 2.27339 5.70314 -0.294719 +531 2 17.8249 15.3246 2.17516 22.0369 -13.9852 -0.651534 +532 1 9.98569 2.74939 12.8982 -9.19221 10.3282 12.793 +533 2 9.83979 2.05829 12.2602 3.07064 -9.86428 -11.8695 +534 2 9.16543 3.26718 12.8794 9.24196 0.527571 1.01071 +535 1 2.93657 8.90297 13.0427 17.8365 13.1008 0.527628 +536 2 3.20967 9.8454 12.9227 -4.18066 -20.4527 0.554358 +537 2 3.74278 8.43516 13.3493 -16.2822 5.83343 -3.94486 +538 1 3.21464 8.50963 3.72772 0.0178718 14.8284 -74.1155 +539 2 3.59865 9.33251 3.32895 -6.0017 -25.5341 4.84747 +540 2 3.33657 8.62148 4.62381 5.38554 5.83243 67.2306 +541 1 5.61344 7.20035 8.58446 -2.8239 -8.19112 0.0562215 +542 2 5.53456 6.24006 8.54079 8.61958 1.67382 -4.34837 +543 2 5.04066 7.41711 9.32304 -1.21443 9.5719 0.536432 +544 1 14.8964 1.44105 1.93253 -7.61412 -10.5809 19.4064 +545 2 14.4541 2.19461 2.37874 12.2686 -5.42452 -16.4906 +546 2 15.2548 1.628 1.06483 0.86569 15.045 -4.43663 +547 1 8.4154 15.1546 0.810786 1.70028 1.58395 -11.225 +548 2 9.17382 15.0707 1.40016 -1.99176 -3.13146 6.02583 +549 2 7.70673 14.5929 1.15135 2.54266 -0.476233 4.63029 +550 1 15.567 1.36482 7.20444 28.1778 15.3746 16.2283 +551 2 15.0185 0.765154 6.74682 -23.3742 -21.8939 -17.7163 +552 2 14.9729 1.99808 7.60632 -6.19001 12.1291 -0.330309 +553 1 5.0089 13.0207 18.4853 -18.4609 -5.74542 -15.9738 +554 2 5.42479 13.0864 0.690362 9.95106 2.52519 17.0862 +555 2 5.65544 13.3331 17.8473 1.85993 1.51979 0.712767 +556 1 15.3671 8.54929 18.1095 -8.15636 -15.968 22.0227 +557 2 15.6817 9.03573 17.3686 11.3034 18.5085 -22.2724 +558 2 15.31 9.18561 0.190372 -2.38163 -0.236806 -1.34825 +559 1 12.0802 3.07221 18.3457 4.60183 -13.894 -6.42275 +560 2 12.4859 2.4 0.260392 -4.96838 8.65649 13.1594 +561 2 12.2775 2.7013 17.4791 -3.58827 6.63097 -2.22236 +562 1 13.1993 12.6855 5.15579 5.61247 -4.39703 15.9491 +563 2 13.8115 11.9693 4.94018 -5.07495 0.365899 -6.13845 +564 2 13.2564 12.743 6.12308 -1.32671 2.90452 -5.88021 +565 1 6.08204 7.19061 0.120725 -6.90673 14.7019 -8.65455 +566 2 5.87336 8.13986 -0.0835188 5.89552 -25.7895 13.7146 +567 2 5.2676 6.79179 0.465292 5.04542 5.75855 -0.526985 +568 1 17.7014 15.9063 14.9696 22.6091 -4.25312 7.62853 +569 2 16.8618 16.3646 15.0156 -4.32677 -2.50983 -14.3551 +570 2 17.9392 15.6583 14.0532 -15.4152 10.9643 9.19951 +571 1 13.1673 0.955706 16.6058 -16.4624 13.9879 0.0318296 +572 2 14.0199 0.765403 16.9805 16.2653 -3.85138 1.37902 +573 2 12.7278 0.106773 16.5459 -0.203322 -8.12911 -4.60325 +574 1 10.9967 14.5844 7.33958 -18.0316 -21.646 7.99268 +575 2 10.1705 14.1548 7.70673 29.6081 10.2394 -10.7243 +576 2 11.7328 13.9554 7.47718 -10.5059 7.23567 0.829732 +577 1 17.5629 8.52802 2.09087 -9.01192 -26.3923 -8.78708 +578 2 16.6633 8.41226 2.4486 12.6056 4.50253 0.467713 +579 2 17.6588 7.73531 1.50133 0.834193 24.7006 12.2923 +580 1 12.3809 7.87992 1.9744 6.05515 -15.9846 -5.53898 +581 2 11.7749 8.59773 2.10936 -4.35558 14.0343 4.46215 +582 2 11.9629 7.32605 1.30246 4.89043 0.565697 0.45699 +583 1 11.9793 14.6347 10.4335 18.2405 9.923 28.253 +584 2 12.2756 14.1199 9.71871 15.2703 -21.0335 -29.0838 +585 2 11.0615 14.7405 10.2767 -32.5541 7.66631 -1.56623 +586 1 6.81522 6.956 15.5295 -17.6641 -14.7432 -7.98444 +587 2 7.71149 6.86909 15.2553 24.3623 -4.30517 -12.3513 +588 2 6.87971 7.6292 16.1782 -5.40685 18.4787 21.7047 +589 1 8.03389 4.5887 13.4155 -37.171 -3.64226 -22.5123 +590 2 7.25568 4.78495 12.82 23.9185 -7.87368 18.6792 +591 2 8.43341 5.43391 13.5743 6.319 9.72574 1.79505 +592 1 13.4002 12.1853 14.3374 -4.54681 1.91445 -1.84351 +593 2 13.053 11.3082 14.1695 -1.05297 -9.08012 2.89826 +594 2 13.8525 12.4201 13.5231 2.34057 5.70396 -2.70792 +595 1 14.6576 9.49709 7.25838 9.71531 18.8932 28.1379 +596 2 15.5128 9.94191 7.46983 -15.999 -8.53149 -8.43731 +597 2 14.0596 9.76702 7.98865 8.11873 -7.0154 -18.3951 +598 1 12.7312 16.9238 3.19475 21.2814 -46.1617 -18.4213 +599 2 12.8913 17.1254 4.09275 6.71284 11.8391 31.6773 +600 2 12.0991 17.5238 2.88672 -32.0955 36.7838 -15.6883 +601 1 1.05963 7.10571 17.4007 12.4792 -13.0695 22.2141 +602 2 0.186546 7.34268 17.7101 -8.13154 -6.52047 1.59159 +603 2 1.15324 7.46505 16.5336 -1.37945 14.6986 -20.6467 +604 1 12.8789 5.0234 15.6828 -31.729 4.63914 -0.239626 +605 2 13.551 4.37036 15.6981 25.2388 -22.1242 0.0408259 +606 2 13.353 5.8465 15.7229 6.14669 17.5754 0.411177 +607 1 2.40704 3.36861 5.12193 5.52974 -41.8871 -53.5671 +608 2 1.82145 3.26591 5.8288 -30.6852 -8.64892 41.0269 +609 2 2.78115 4.20498 5.20734 26.4804 50.2953 11.9131 +610 1 8.27515 11.124 13.5771 -2.85187 11.2881 -70.0801 +611 2 8.37295 10.8581 14.431 -1.92558 -15.2628 85.0569 +612 2 8.99363 10.6344 13.1748 6.72692 3.2721 -14.9 +613 1 12.918 1.48119 13.2724 -5.46048 -28.9446 23.2516 +614 2 13.637 1.39783 12.6661 14.6279 -0.945194 -20.1211 +615 2 12.6406 2.36931 13.1901 -10.8983 31.3672 -5.19186 +616 1 6.50945 13.6334 2.15016 9.54562 -3.73103 -23.7728 +617 2 5.85792 13.9589 2.75542 -11.9505 6.96003 17.098 +618 2 7.07728 13.0286 2.63475 0.813075 1.46302 3.43305 +619 1 15.9192 6.52891 12.704 16.1802 17.7634 -8.70325 +620 2 16.3422 7.10874 12.0232 -9.40583 -17.3352 17.4966 +621 2 16.4304 6.67694 13.5293 -11.6709 -4.5663 -12.9766 +622 1 16.8012 0.7168 9.58424 5.37965 28.6432 5.104 +623 2 16.9134 18.4317 9.69441 -4.13374 -28.9785 4.85106 +624 2 16.4797 0.860059 8.69243 -6.31121 -1.15561 -8.50241 +625 1 6.13999 11.6637 8.32406 3.84263 60.0529 3.8669 +626 2 5.34748 11.493 8.80779 -22.31 -6.18549 9.45125 +627 2 6.46273 10.8378 8.08078 19.7827 -51.2376 -16.1138 +628 1 2.82548 8.7059 0.356008 25.1404 7.14145 17.7175 +629 2 2.1872 8.20684 18.5458 -21.47 -27.2684 -27.7438 +630 2 2.28201 9.37487 0.754925 -1.41085 15.0233 10.6798 +631 1 10.1039 10.4509 6.57992 -4.79526 -6.25674 7.70278 +632 2 10.5083 9.74309 7.09516 2.94215 -0.723708 0.948173 +633 2 10.6276 10.5201 5.78606 4.97834 -0.717699 -12.6856 +634 1 6.77313 15.7547 6.63388 -5.578 -17.4503 -5.92282 +635 2 7.15743 16.0375 7.46176 7.11582 8.10879 3.23091 +636 2 7.28529 16.1142 5.89948 -1.84538 11.4125 4.1387 +637 1 6.44197 13.0281 5.69829 11.2984 8.90971 -1.05733 +638 2 6.79679 13.8886 5.97631 -5.91305 -5.55439 0.155281 +639 2 6.12445 12.6032 6.49753 -3.74834 -3.51916 3.00547 +640 1 16.7803 12.5246 9.7433 1.48678 16.9805 10.4147 +641 2 16.9869 12.0132 8.97443 1.49858 -19.0548 -12.8116 +642 2 17.3026 13.3224 9.61445 -4.02823 0.499055 5.20393 +643 1 6.14077 2.94238 2.79674 5.90568 12.9134 -1.15866 +644 2 6.37771 3.87334 2.54509 -6.86675 -27.0997 0.367621 +645 2 5.77601 2.45475 2.03942 1.6023 9.98348 0.439644 +646 1 10.8329 3.18005 3.24633 -5.48645 -3.34604 -3.46544 +647 2 10.1887 3.87164 3.40992 -1.49044 3.74393 4.82403 +648 2 10.5052 2.73309 2.45537 3.4248 -0.0323397 2.60803 +ITEM: TIMESTEP +60 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.78901 6.89398 17.9776 -3.5234 1.93788 3.89787 +2 2 7.91305 7.05712 18.3419 -1.4277 0.241332 2.63834 +3 2 8.67661 6.15674 17.3832 1.3639 -6.15529 -7.04239 +4 1 18.7561 8.31771 6.77309 10.5748 -7.50476 -33.4266 +5 2 0.457617 7.9886 5.89382 -17.7288 16.9324 23.762 +6 2 0.568724 7.76979 7.40723 1.86737 -7.24646 12.6232 +7 1 8.51532 18.7703 6.84705 0.662358 -5.68449 9.56329 +8 2 9.4329 0.211311 6.58737 4.53489 1.21926 -2.36791 +9 2 8.05203 0.803554 6.35578 -1.87482 6.91549 -4.54998 +10 1 6.50103 1.76445 11.707 -23.9337 -6.76257 7.94266 +11 2 5.68898 2.17855 12.0897 23.4576 -7.00878 -10.5629 +12 2 6.21872 0.874053 11.3985 3.54415 20.4784 6.13886 +13 1 7.00577 5.62696 2.40487 20.8008 -18.6778 -13.9491 +14 2 6.3381 5.93149 2.99593 -12.7158 11.2498 18.9927 +15 2 6.96044 6.19487 1.63998 -3.33571 5.44078 -9.1088 +16 1 16.2317 10.2379 16.0906 -2.65398 7.02849 4.45196 +17 2 17.1094 10.623 16.0697 3.52116 -7.47169 -6.62031 +18 2 15.6835 10.996 16.3292 -1.12895 -7.31017 -0.603728 +19 1 10.664 14.9341 2.30567 13.0251 3.56406 6.3158 +20 2 10.7336 14.2976 3.03428 -5.34804 6.23285 -3.50086 +21 2 11.2229 15.6743 2.58509 -4.07292 -1.48419 -0.585019 +22 1 17.1728 8.23947 10.7128 -1.64499 -1.99855 0.608593 +23 2 16.6728 8.84067 11.2819 0.316783 0.889357 -0.63917 +24 2 17.9322 8.74349 10.3965 1.71935 0.329185 -1.07247 +25 1 14.697 15.9473 16.4368 -13.7705 -0.197196 -7.11694 +26 2 13.7879 16.279 16.3001 13.6207 -4.8592 3.02749 +27 2 14.6438 15.4158 17.2461 5.07545 7.5417 -4.99128 +28 1 12.1134 13.367 0.528093 -6.39608 9.01831 -4.72995 +29 2 11.8173 13.4954 18.2644 6.74141 -8.66363 -5.87361 +30 2 11.5587 13.987 1.01769 3.38254 -3.71164 8.60635 +31 1 9.30318 5.47999 3.94883 35.8178 1.45581 -2.5285 +32 2 8.76671 5.2044 4.67379 -16.9173 -4.15595 18.9992 +33 2 8.71572 5.58687 3.21666 -20.2172 1.55363 -14.8227 +34 1 1.70529 4.08306 11.601 -3.00308 -9.11056 -2.97947 +35 2 1.52513 4.97184 11.9147 2.37337 9.05749 0.600173 +36 2 2.22567 3.63839 12.2786 -1.82607 -0.283286 1.9059 +37 1 2.04499 6.82744 8.26893 9.18028 14.0429 7.96475 +38 2 2.5896 7.29904 8.93262 -11.3816 -6.25496 -6.31442 +39 2 1.81536 5.98181 8.67357 4.33854 0.450625 -3.71013 +40 1 5.3656 4.4774 7.93824 1.44041 9.72132 7.59831 +41 2 5.44269 3.52851 7.84762 -1.19648 -12.0175 -6.62376 +42 2 4.92598 4.83778 7.16432 -9.0894 -3.97332 -7.9273 +43 1 3.32251 2.9413 17.4443 0.538374 -34.3486 -6.77872 +44 2 3.98642 3.24962 16.8336 8.9197 7.73227 -3.39959 +45 2 3.04976 3.68399 17.9526 -12.2781 23.4468 13.5982 +46 1 7.437 5.38423 6.13063 5.01567 -0.272219 -26.6536 +47 2 7.97737 5.94965 6.66546 10.8347 10.076 12.8667 +48 2 6.99068 4.78917 6.71033 -9.3836 -11.0864 17.8628 +49 1 9.80479 7.01238 12.0379 -9.46641 4.39554 -21.4508 +50 2 10.3276 6.40912 11.4906 -4.30802 3.34771 7.14548 +51 2 9.13044 7.38666 11.4225 10.4612 -8.54147 15.485 +52 1 14.0024 3.65677 8.07153 1.90613 10.1899 13.6881 +53 2 13.9361 4.48059 7.56554 -1.4656 -7.0627 2.39316 +54 2 14.1946 3.93561 8.9889 0.417494 -3.38136 -15.0381 +55 1 4.51888 17.1453 3.95588 7.87944 -4.67708 3.20643 +56 2 5.41436 17.4585 3.90856 16.3959 1.38908 8.05638 +57 2 4.13204 17.4705 3.15493 -16.1768 7.51082 -11.5461 +58 1 16.4506 16.6012 10.3314 -28.9812 -6.12917 4.01051 +59 2 15.5905 16.5574 10.8183 20.4446 2.48532 -11.9951 +60 2 16.2667 16.1387 9.49338 0.364513 2.67256 9.91326 +61 1 1.97065 4.79938 0.260671 -8.10245 -17.5737 -13.0373 +62 2 2.41281 5.12274 1.03667 10.218 10.6244 9.40508 +63 2 1.8267 5.54768 -0.321227 -3.59337 9.6389 -0.147197 +64 1 11.5035 13.2586 16.3577 -0.713967 20.2415 12.8794 +65 2 11.0441 12.4305 16.4814 -6.19498 -9.28579 -2.23027 +66 2 12.0754 13.1484 15.6021 5.65191 -4.41955 -9.63321 +67 1 10.1276 11.0105 16.8449 -6.46201 16.5427 1.83518 +68 2 10.5556 10.1721 16.794 12.0656 -22.7421 -1.13044 +69 2 9.20289 10.8171 16.6996 -9.212 1.56961 -0.130134 +70 1 11.787 17.4505 13.4822 -3.74088 11.88 -4.97071 +71 2 12.2373 16.9277 12.8063 6.56705 3.4706 4.72845 +72 2 12.0251 18.3805 13.3063 -1.30808 -7.68873 2.97322 +73 1 6.42132 9.37259 12.2366 13.1698 8.24141 3.19081 +74 2 6.99069 9.01867 11.5406 -12.3498 -0.982732 4.41902 +75 2 7.03807 9.88277 12.7853 -8.70879 -2.27031 0.0855326 +76 1 16.2815 12.8722 2.70224 -2.02351 7.50879 0.830271 +77 2 17.1172 13.3658 2.56775 -16.1548 -5.18742 1.80773 +78 2 15.5334 13.5108 2.69253 18.3367 -6.33955 1.64103 +79 1 0.729913 12.6587 5.89268 5.90957 5.27776 3.54404 +80 2 1.01336 12.4973 4.99287 4.32656 -0.558571 -7.43154 +81 2 18.4322 12.7877 5.81211 -15.2269 -3.44557 0.704235 +82 1 5.2582 16.4249 18.4194 -10.384 10.1199 -1.35479 +83 2 5.6864 15.6785 18.0038 6.48963 -9.24773 3.62069 +84 2 5.52942 16.4885 0.694307 6.00107 -3.50652 -0.438993 +85 1 0.618748 7.72132 4.16911 -57.0293 -28.7954 36.7096 +86 2 18.6577 8.06272 3.52122 -10.6934 7.30065 -13.2418 +87 2 1.44908 7.88182 3.83946 68.942 18.8036 -26.9673 +88 1 3.13476 8.97804 6.4725 9.50813 11.9402 -13.0637 +89 2 3.74054 8.49646 7.01761 11.8689 -6.06991 10.2621 +90 2 2.28514 8.86225 6.86989 -19.244 -2.30506 4.89646 +91 1 7.29998 10.3842 16.2581 17.8205 -0.109318 -17.8263 +92 2 6.62843 10.5749 15.608 -5.58859 2.04705 -1.34953 +93 2 6.87201 10.3756 17.1052 -6.43011 -2.48695 12.6131 +94 1 11.0863 0.954938 5.00203 0.851153 5.26347 3.05665 +95 2 11.191 1.83687 4.62341 -3.02583 0.75042 -0.451702 +96 2 10.8235 0.406956 4.25776 -2.05383 -4.79736 -1.16032 +97 1 4.33613 2.85707 13.1911 1.54519 27.1095 -5.33994 +98 2 4.57692 3.1724 14.0657 0.352889 6.79614 0.336856 +99 2 4.2364 1.93118 13.308 -7.70759 -34.1778 4.58716 +100 1 8.4203 10.2079 1.80876 2.06346 -1.14808 -20.454 +101 2 8.303 10.9031 2.4489 -3.41662 7.51624 10.9075 +102 2 8.71506 9.44854 2.30018 2.97787 -12.0816 9.03727 +103 1 10.3977 1.70625 15.5267 1.73644 2.79304 1.06494 +104 2 11.3647 1.6343 15.5026 -8.09264 -2.44943 -3.11689 +105 2 10.0867 1.93234 14.6348 6.55478 -0.658466 2.12488 +106 1 2.65181 12.9273 7.85805 -0.311785 2.06689 -1.07798 +107 2 3.23228 13.5447 7.39928 3.74905 0.741997 1.40009 +108 2 1.98379 12.6968 7.20259 -0.999427 -0.794231 1.07688 +109 1 3.77953 11.641 5.00453 4.18201 7.36008 7.19136 +110 2 3.61117 10.803 5.43181 -1.00449 -4.29555 7.12479 +111 2 2.98088 11.8656 4.52857 -4.84381 -0.0516249 -5.594 +112 1 6.70671 14.4383 16.9441 -2.88793 7.65462 4.66357 +113 2 7.46032 14.9632 17.2378 1.25427 -2.15328 -4.6823 +114 2 6.29331 14.8741 16.1864 7.83964 -2.53039 -3.71142 +115 1 14.1974 14.5272 3.32557 -8.64957 0.126228 1.77541 +116 2 13.6145 15.2324 2.99689 6.18241 -4.15847 9.95625 +117 2 13.7792 14.1343 4.11346 2.7139 4.36583 -10.9531 +118 1 8.49626 18.0895 16.0579 -56.9361 5.6973 -1.31016 +119 2 8.97799 17.2887 16.1101 31.3098 -20.0295 7.70991 +120 2 8.99116 0.248943 16.0582 28.7181 13.2998 -3.6499 +121 1 4.72072 1.70195 4.90499 9.17194 -24.9679 14.1726 +122 2 3.98364 2.22531 5.16555 -23.8501 10.7625 5.04957 +123 2 5.10611 2.17516 4.19081 15.0133 13.348 -19.3674 +124 1 15.0233 12.5839 16.4881 -18.3113 17.2758 -0.569629 +125 2 14.531 13.0978 17.1312 10.6463 -2.17552 11.3526 +126 2 14.3728 12.5238 15.7796 8.99848 -7.00837 -8.88439 +127 1 15.6995 18.4783 16.8755 -18.8856 10.9503 -24.4051 +128 2 16.4938 18.4127 17.3644 26.3461 0.942046 24.9737 +129 2 15.418 17.5728 16.7613 -4.49112 -11.2036 -1.17338 +130 1 1.28835 1.23059 16.5761 -5.93248 -0.138309 0.14802 +131 2 2.13994 1.64325 16.7078 7.79309 6.58334 -0.470261 +132 2 0.740967 1.66098 17.2372 -5.253 -1.12337 3.85618 +133 1 18.1629 4.44327 15.9115 -6.79632 -1.27318 -1.28488 +134 2 18.1308 3.86521 15.1462 0.0573414 -0.0912133 -1.44422 +135 2 0.437875 4.54116 16.1499 5.78898 1.89854 1.50737 +136 1 12.2373 17.0002 16.1546 0.545523 9.79929 -13.3931 +137 2 11.4461 16.6427 16.5433 -11.0844 -6.7728 9.10484 +138 2 12.011 17.1373 15.2222 3.0182 -2.09591 3.06353 +139 1 16.0678 2.55904 18.1722 10.2246 -6.29614 14.7907 +140 2 15.8342 3.46829 18.3235 -8.81825 14.1289 4.59946 +141 2 15.8732 2.39245 17.2622 -4.4601 -2.08833 -19.809 +142 1 6.72425 13.805 10.1648 -2.60578 6.66979 -6.33116 +143 2 6.49371 13.5045 11.0525 -0.564993 -6.25943 -2.37403 +144 2 6.44263 13.1457 9.51237 3.71898 -2.3263 8.04067 +145 1 10.1796 18.3897 2.72456 -2.84724 -9.82946 6.47371 +146 2 10.454 0.395639 2.08514 4.83004 8.04726 -9.16723 +147 2 9.37175 18.0281 2.35385 -6.15379 0.681222 3.71385 +148 1 3.03584 17.7169 6.12875 -8.09623 -9.32203 -7.45056 +149 2 2.18289 17.4189 5.74043 17.1828 11.6191 3.33552 +150 2 3.689 17.6882 5.40781 -11.2408 2.0569 5.59443 +151 1 12.6056 16.8615 7.96971 24.61 3.09247 -20.49 +152 2 12.0094 16.1192 7.91607 -18.906 -3.75998 3.49802 +153 2 12.4208 17.4479 8.69718 -9.87831 1.59818 13.2946 +154 1 14.8851 15.258 8.17849 4.86996 1.69705 3.53461 +155 2 13.9994 15.6489 8.25275 11.2692 6.96129 -5.86816 +156 2 15.346 15.6481 7.40987 -12.7499 -9.2219 7.50011 +157 1 17.7579 18.2305 0.335063 13.8809 -6.66068 -7.77561 +158 2 18.5388 17.6427 0.115787 -18.9695 29.962 7.44433 +159 2 18.0215 0.522838 0.460167 3.90753 -19.2563 -2.82208 +160 1 0.789759 10.4825 1.35847 3.51968 14.2812 -7.72333 +161 2 0.0798625 9.88631 1.6077 -6.45512 -1.46576 0.207918 +162 2 0.407025 11.2033 0.810215 7.48025 -15.8311 11.8414 +163 1 1.75759 12.251 3.36651 -3.2997 0.800224 -5.24767 +164 2 1.53389 11.5715 2.69671 0.947411 14.52 5.02147 +165 2 1.90006 13.112 2.93145 -3.03991 -14.1386 -4.6936 +166 1 0.626528 17.2392 4.94747 0.535799 -10.8391 4.53682 +167 2 18.8821 18.137 4.96158 -2.27873 -17.8214 11.6149 +168 2 0.354378 16.6324 5.68648 2.97307 28.5848 -17.7586 +169 1 1.10952 0.863641 9.39152 -13.7339 -4.40866 12.9037 +170 2 1.31873 0.587529 10.3088 -1.45288 2.90017 -16.0983 +171 2 0.209028 0.525909 9.24512 10.3392 4.25606 -0.349363 +172 1 16.7392 2.34887 13.3076 6.86896 9.31967 14.159 +173 2 16.9447 2.54868 12.3949 -1.60073 1.25233 -7.99088 +174 2 16.5723 1.40956 13.3727 -4.20045 -10.3799 -4.26178 +175 1 2.67499 15.8791 12.0838 -15.6649 13.6026 18.6328 +176 2 3.08767 15.4473 12.8331 1.25238 -1.62775 -1.314 +177 2 3.09072 15.5563 11.2931 8.09534 -6.35014 -12.1736 +178 1 16.4274 15.6453 6.10859 -17.0431 -16.804 0.948824 +179 2 17.3058 15.6768 6.44562 21.0308 -4.79075 10.9 +180 2 16.4023 16.3397 5.46924 -8.03031 15.1286 -15.2988 +181 1 5.80151 5.1106 11.8034 -9.99749 12.6805 7.50019 +182 2 5.41461 5.91177 12.2246 6.41162 -14.9692 -6.22456 +183 2 5.12172 4.42339 11.8362 4.25931 3.80702 2.95737 +184 1 15.1575 4.86793 0.802761 22.7174 4.42582 -27.0135 +185 2 14.9254 4.50834 1.64009 -5.31496 -5.26411 26.4075 +186 2 14.3858 5.30472 0.469017 -12.1413 5.82456 -3.82743 +187 1 16.3769 16.3844 2.01422 -5.72057 14.22 1.10565 +188 2 15.9278 16.7493 2.80314 10.8683 -6.01604 -9.24812 +189 2 16.773 17.1531 1.56448 -5.22082 -7.76197 3.40899 +190 1 0.23965 4.83003 3.84895 -16.8427 -30.7507 -16.2196 +191 2 0.252698 5.75131 3.99923 2.34384 38.0203 4.84997 +192 2 0.859131 4.45396 4.45569 14.7994 -7.19156 9.40612 +193 1 2.95205 15.0559 15.135 12.255 2.89982 -34.0079 +194 2 2.82691 14.77 16.0276 -6.33331 -2.96333 21.8089 +195 2 2.70057 15.9867 15.0833 -9.42631 -1.00353 7.2626 +196 1 1.12786 14.6523 9.50314 0.137917 -12.6668 4.07712 +197 2 1.90226 14.1941 9.14772 -4.18616 2.58129 -2.64264 +198 2 0.826039 14.044 10.1958 0.138103 8.11094 -6.03497 +199 1 13.5191 16.5585 11.5327 7.73147 -8.17374 8.97592 +200 2 13.1298 17.2703 11.0385 -2.21772 17.726 -8.86187 +201 2 13.0359 15.7976 11.2032 2.83922 -8.38127 -1.58332 +202 1 4.66669 1.44213 0.750789 16.1276 9.43437 -4.32571 +203 2 4.14083 2.03292 0.213208 -5.20243 5.56453 -6.36037 +204 2 4.0469 0.85314 1.17877 -1.04658 -3.40534 3.74731 +205 1 1.47829 18.5621 11.858 5.51121 1.25702 19.3245 +206 2 1.35114 0.550992 12.5892 2.53269 -8.70306 -5.34898 +207 2 2.06733 17.8728 12.2103 -6.7512 4.69931 -6.32602 +208 1 11.4685 10.1386 3.99675 -31.6511 -19.8648 40.1611 +209 2 11.3534 10.4173 3.11507 -1.88937 16.5167 -32.0622 +210 2 12.3922 10.1317 4.15588 31.92 0.339396 6.83567 +211 1 8.2329 12.185 3.6562 14.6677 -4.21505 -16.0366 +212 2 9.0609 12.5679 3.94713 7.11932 4.3628 2.52934 +213 2 7.63223 12.3212 4.36927 -17.6963 1.05811 24.4992 +214 1 14.5368 4.0151 3.29112 -13.123 -7.80297 -23.8392 +215 2 15.0981 3.94713 4.04639 13.729 3.5857 20.4451 +216 2 13.7669 4.51912 3.55347 -6.0046 4.6829 5.42155 +217 1 5.65486 1.65777 7.52148 58.4475 40.9395 -13.9317 +218 2 4.99661 1.25201 7.99959 -53.8788 -37.1346 38.2946 +219 2 5.51095 1.40377 6.61889 -5.49301 1.61126 -19.8188 +220 1 17.8901 1.045 4.84749 -9.94718 -16.9222 0.488244 +221 2 18.5122 1.52388 4.30334 5.34684 7.49098 -3.2278 +222 2 17.6047 1.57034 5.59464 4.63979 8.2364 3.24002 +223 1 6.81309 9.39039 4.50819 3.0131 -8.49785 6.19054 +224 2 6.80308 9.57416 5.46384 1.81054 -3.72037 -9.62081 +225 2 7.68859 9.02244 4.29465 -5.74329 4.97879 4.89484 +226 1 2.5752 14.8387 1.99973 -14.8295 0.871449 -1.75437 +227 2 3.26878 14.7632 2.65166 10.803 -1.54702 2.65568 +228 2 2.97003 14.8559 1.12279 1.99123 -2.02101 2.0261 +229 1 17.298 12.9204 13.1492 -3.4846 16.1956 -6.51124 +230 2 16.423 13.308 13.3278 8.68723 -6.18077 0.438899 +231 2 17.8438 13.7012 12.9334 -6.61166 -12.0077 2.21466 +232 1 14.9034 10.5534 1.40093 -1.35277 29.2651 19.5565 +233 2 15.388 11.3453 1.77149 -13.4573 -26.0533 -12.1606 +234 2 13.9634 10.6773 1.62965 16.0361 -2.08776 -5.28169 +235 1 5.72986 6.65162 4.58435 -17.0557 15.5593 -6.14164 +236 2 5.84842 7.61417 4.55049 3.33824 -4.32419 -0.681988 +237 2 6.28697 6.32726 5.29234 8.09232 -2.61709 -0.816212 +238 1 7.99944 8.35521 10.3848 17.9936 -2.63811 -6.27588 +239 2 8.59251 9.07404 10.0893 -6.48701 -11.154 -5.32581 +240 2 7.88909 7.71789 9.66296 -2.42609 11.6503 -0.200638 +241 1 13.4241 18.44 5.69275 23.5538 0.0525075 -9.71433 +242 2 12.6953 0.391603 5.53139 -12.0458 3.72648 -1.32391 +243 2 13.2482 18.017 6.52624 -8.74326 -11.7295 10.7578 +244 1 0.0158155 2.64508 0.27395 14.5716 -58.678 15.8132 +245 2 17.7841 2.79898 -0.0392974 -21.1138 14.4347 -10.6776 +246 2 0.56739 3.397 0.238244 13.7063 38.8805 -4.38724 +247 1 12.8888 11.0203 9.74081 14.4921 -25.5472 6.65601 +248 2 11.9442 11.0265 9.60333 -9.9467 -3.56544 -1.05488 +249 2 13.1018 10.1085 10.0646 -8.85698 19.3484 -7.35591 +250 1 0.676749 12.1402 11.0769 -15.7222 13.4662 19.3247 +251 2 18.361 12.1632 11.2371 5.51909 -2.16069 -8.49445 +252 2 1.03381 12.419 11.9274 8.68848 0.134808 -1.80861 +253 1 5.1281 7.32638 13.4074 12.574 7.81643 0.126088 +254 2 5.56178 8.11083 13.0117 -0.574951 -12.9077 2.36295 +255 2 5.67541 7.10745 14.1812 -7.25639 3.83801 -6.5213 +256 1 1.19691 6.83481 11.9192 5.63437 23.0857 0.0567084 +257 2 0.430704 7.22717 11.4609 12.0202 -4.44614 6.83847 +258 2 1.80476 7.59103 12.1282 -18.5438 -19.7012 -5.0003 +259 1 15.5112 9.6605 12.308 7.39931 -23.3592 2.14975 +260 2 15.3284 10.5626 12.1388 -11.1565 28.2269 -10.7029 +261 2 15.46 9.608 13.2546 2.72926 -7.26454 12.4411 +262 1 16.5981 12.7055 5.55132 5.93792 -6.99565 4.13948 +263 2 16.3871 13.6216 5.72312 -3.40713 11.8574 1.85996 +264 2 16.4508 12.5854 4.61105 -1.1211 0.407027 -8.19974 +265 1 6.341 9.80883 0.0188309 -5.87145 18.2236 11.3739 +266 2 5.58583 10.3592 0.271383 3.51693 -3.70717 1.01998 +267 2 6.97723 9.90576 0.746734 -2.19026 0.0209431 -7.09875 +268 1 12.2976 6.11648 4.05009 -7.99316 6.14403 -18.1211 +269 2 12.258 6.83685 3.38221 3.50754 -15.1435 11.6411 +270 2 11.4736 5.62673 3.91242 4.22123 1.1153 4.56647 +271 1 0.341758 12.8367 0.152932 -4.41368 -4.71323 -6.18075 +272 2 -0.071293 13.3938 0.818389 4.38543 6.64898 2.3316 +273 2 18.4831 12.9746 17.9873 -4.56942 3.87447 -1.94524 +274 1 3.61813 18.6313 8.61443 0.661139 8.76689 2.03667 +275 2 3.46056 18.3752 7.69711 -0.554223 -6.30588 2.24303 +276 2 2.77043 0.354615 8.90695 5.13325 -4.08936 -2.3138 +277 1 7.42355 17.3409 4.4768 -7.56741 1.42105 -0.716546 +278 2 7.51902 18.2689 4.68925 3.30463 5.13228 6.51734 +279 2 7.58206 17.32 3.5353 -0.521854 -4.80047 -8.50069 +280 1 9.24832 17.1301 12.2139 -13.1815 7.8308 -4.22869 +281 2 9.33905 16.301 11.7591 -2.0028 -14.1862 -9.75618 +282 2 10.0447 17.2202 12.718 16.3553 3.99578 13.5609 +283 1 13.2894 13.0415 8.03267 8.35671 10.0486 -9.41069 +284 2 13.3695 12.1786 8.4589 5.84428 6.69767 4.94138 +285 2 14.1604 13.5085 8.0433 -18.6948 -10.3528 3.9365 +286 1 14.8481 2.99092 15.3927 0.856118 4.40098 19.7153 +287 2 14.1706 2.3196 15.3374 -5.14829 -8.82459 -5.54141 +288 2 15.3789 2.92995 14.603 5.00888 -0.952448 -11.2281 +289 1 9.90287 15.5907 16.9887 3.86064 7.54266 0.708681 +290 2 10.4376 14.8321 16.7196 -3.05759 -5.14225 0.11478 +291 2 9.69704 15.4836 17.9287 -2.19155 -3.5869 -5.21272 +292 1 11.3068 8.44228 16.6046 -8.18504 -5.87812 -2.49231 +293 2 10.7375 7.86962 16.0559 4.371 7.7216 8.33293 +294 2 11.2933 8.06373 17.4959 1.16379 -1.60832 -8.83864 +295 1 4.00007 18.2264 16.7774 4.24494 10.2639 17.5421 +296 2 4.56172 17.6396 17.2965 -1.57319 -6.32646 -5.9019 +297 2 3.85664 0.302165 17.4089 -1.12143 -0.586814 -11.7526 +298 1 2.2479 4.22742 8.91978 -15.7964 -0.236851 -9.315 +299 2 3.17417 4.26053 8.71033 14.3134 -0.385935 -1.23962 +300 2 2.16897 4.01078 9.84529 1.80454 -0.809508 12.1296 +301 1 9.87751 10.3883 9.74788 10.9603 -30.3507 -6.41167 +302 2 9.55849 11.2198 9.44401 -12.062 25.9436 -6.06801 +303 2 10.0779 10.4258 10.6774 1.92757 5.46095 17.7276 +304 1 9.69765 0.927205 10.8701 14.9831 -0.992619 -3.75191 +305 2 9.43595 0.039964 11.1566 -10.0783 4.56951 -4.94264 +306 2 9.12787 1.25731 10.1583 -1.53115 -8.98556 4.28196 +307 1 9.19006 15.088 10.2066 22.8811 13.4843 7.03893 +308 2 8.82905 15.9231 9.90375 -5.23887 5.212 -7.88342 +309 2 8.4517 14.4971 10.2333 -16.9878 -12.2258 -0.936878 +310 1 0.910091 9.64474 10.2618 6.35784 -25.2235 -17.0921 +311 2 0.848571 10.4636 10.7331 2.68282 16.4495 1.28733 +312 2 1.6853 9.71195 9.67503 -11.8234 -0.16557 12.5577 +313 1 17.0493 4.85425 8.1315 23.124 -12.0189 -22.071 +314 2 16.5036 5.57379 8.38464 -19.6085 19.0848 9.20549 +315 2 17.0051 4.2127 8.82658 -1.69519 -7.20825 12.6053 +316 1 14.7684 14.7087 0.123438 -2.69691 -12.5371 -11.3918 +317 2 15.061 15.3506 0.758659 10.1685 10.0196 13.4831 +318 2 13.9556 14.337 0.462955 -8.28455 -4.39651 5.72223 +319 1 3.75153 11.0481 9.53582 4.71209 -10.2499 1.98044 +320 2 3.63189 11.3357 10.4456 -0.734234 5.70871 5.17654 +321 2 3.24354 11.632 8.96907 -2.43681 8.8531 -2.47663 +322 1 11.2519 10.7463 1.5017 8.48932 -12.5201 -0.266865 +323 2 11.5908 11.5519 1.12329 1.64528 14.0457 -7.10687 +324 2 10.3311 10.688 1.26079 -12.3399 1.77059 -3.9568 +325 1 13.1496 7.17281 12.6854 5.50111 -7.8338 2.87732 +326 2 14.101 6.95885 12.7444 -10.2033 1.82309 -0.47089 +327 2 12.6663 6.34751 12.851 5.63542 3.55 -1.50526 +328 1 9.61828 1.90104 0.967862 -1.73511 6.80555 -16.7575 +329 2 8.75126 1.82608 0.511852 18.7109 -2.38487 5.6602 +330 2 10.2637 2.29933 0.349253 -13.3131 -4.11214 4.99441 +331 1 10.6435 13.4896 4.54607 -8.3754 1.2658 -1.96254 +332 2 11.4795 13.0515 4.69791 8.28938 -6.58305 0.731496 +333 2 10.5798 14.1432 5.24738 -1.32643 -0.553656 5.74704 +334 1 14.4543 1.71115 10.9546 -7.69161 -4.81009 -3.91494 +335 2 15.2136 1.28396 10.5547 4.80162 -2.13195 -1.67599 +336 2 14.6015 2.65135 10.8079 -1.60778 0.935868 6.54178 +337 1 14.5384 12.1186 11.6682 4.42158 0.0609916 50.1985 +338 2 15.3244 12.3738 11.2188 19.3883 10.0258 -22.7848 +339 2 13.838 12.0043 11.0592 -19.2299 -5.1918 -28.9193 +340 1 8.19636 5.07775 9.81895 6.92668 -2.08004 -5.22277 +341 2 7.38544 5.24812 10.3055 -3.33886 -3.05544 1.61921 +342 2 8.19204 4.12852 9.59915 -2.53054 10.0553 1.98192 +343 1 1.48663 16.8897 18.439 7.38955 -7.44055 -8.00122 +344 2 1.97341 17.2271 17.6702 -6.10601 -1.16576 3.12224 +345 2 1.43805 15.9298 18.2902 4.85843 10.0488 4.15854 +346 1 1.49392 17.3013 15.324 -13.7543 10.7593 4.06087 +347 2 1.44447 18.24 15.6259 -3.67575 -24.1287 -4.86768 +348 2 0.590882 16.9129 15.3122 14.6177 13.551 2.26757 +349 1 3.61646 5.75696 6.06482 3.05275 -16.2413 -2.75756 +350 2 3.17 6.32551 6.68313 -10.4039 6.81614 9.87761 +351 2 4.1613 6.3181 5.51248 5.12466 2.54076 -5.58469 +352 1 12.4579 9.47416 14.2028 -15.1686 39.1263 4.59508 +353 2 12.91 8.74193 13.8564 21.0065 -34.4741 -21.4004 +354 2 12.311 9.21984 15.1046 -5.21536 -3.05923 17.073 +355 1 4.05954 15.2722 6.9713 -12.2847 -13.6907 9.03639 +356 2 3.52733 16.0267 6.71946 -3.69787 8.1984 -1.38185 +357 2 4.94462 15.4979 6.70957 17.3953 3.39893 0.124931 +358 1 0.676716 8.64845 15.0435 0.0448789 -8.8726 2.29819 +359 2 0.388517 9.55355 15.1457 -0.102902 11.258 0.0552156 +360 2 1.38121 8.67263 14.3922 3.78483 -0.0353447 -4.44966 +361 1 12.9131 8.29224 10.2146 2.07907 -10.3878 2.68575 +362 2 13.6346 7.78925 9.80195 -2.79275 5.95566 3.91371 +363 2 12.8029 7.87463 11.0885 3.60602 9.09063 -7.955 +364 1 15.3505 7.77425 3.51602 -25.105 2.18251 -0.815364 +365 2 14.4666 7.51634 3.2857 -7.66712 2.41401 -31.383 +366 2 15.2516 7.5997 4.43625 29.5189 -3.75051 28.1293 +367 1 17.2908 6.71242 0.0288264 8.4359 -0.0595562 3.38218 +368 2 16.7481 6.02838 0.414195 -4.41494 -10.5616 1.77026 +369 2 16.6696 7.39667 18.4317 -9.71571 9.06541 -4.14994 +370 1 8.93558 6.94317 7.77066 11.3734 11.9101 1.30985 +371 2 9.8513 7.28708 7.82315 -13.5624 -4.9569 -0.419932 +372 2 8.83457 6.3282 8.49913 -0.351333 -9.82053 6.39411 +373 1 12.3886 0.605922 1.26733 4.3474 1.63423 -5.64369 +374 2 13.3496 0.62067 1.39833 -3.50709 5.26207 -1.10414 +375 2 12.2365 0.554465 0.317002 3.44844 -5.08055 2.164 +376 1 5.6093 15.1332 14.5298 5.50237 -6.63524 -3.85361 +377 2 4.67729 15.3131 14.6547 -7.5977 -3.56809 4.17708 +378 2 5.99198 15.9265 14.1501 5.33744 7.17763 0.920224 +379 1 3.83862 6.42399 1.72255 -0.530245 0.761181 6.81888 +380 2 3.42185 7.23588 1.41886 -3.5948 7.2146 -3.68667 +381 2 3.94102 6.55655 2.67261 0.00170673 0.796504 -2.59346 +382 1 3.90756 11.5263 12.3817 0.20855 -7.47029 -8.65749 +383 2 4.79535 11.8927 12.4625 -0.681042 -1.53834 0.918823 +384 2 3.33577 12.1179 12.8713 -4.93373 1.57702 0.731635 +385 1 5.31593 3.88159 15.8542 -0.71358 -42.6288 -12.177 +386 2 5.97198 3.22378 15.5406 -6.31298 7.40988 7.32158 +387 2 5.73536 4.71214 15.7787 14.3185 32.9857 -0.935745 +388 1 14.2562 10.2258 4.56557 -18.8652 24.4894 6.04548 +389 2 14.4389 9.92543 5.45169 -1.13053 -5.88778 11.8213 +390 2 14.6954 9.63367 3.98806 17.1426 -20.2086 -20.2139 +391 1 7.6892 17.381 9.10447 19.4711 -25.2283 0.682627 +392 2 6.86971 17.6207 9.51632 -14.1206 10.5396 4.24559 +393 2 7.90224 17.9622 8.37374 -3.5427 12.2774 -4.18627 +394 1 4.51373 14.5018 3.89084 0.522587 -13.0056 -37.966 +395 2 4.5996 15.4052 4.14706 0.258928 20.2029 10.6105 +396 2 4.49773 13.963 4.65868 1.58881 -14.8294 26.2191 +397 1 14.2556 7.39762 15.8429 -9.24001 -8.17606 -10.1746 +398 2 15.1854 7.31956 15.6389 10.3704 -1.38951 -4.38862 +399 2 14.2355 7.83779 16.6857 -0.295639 4.56275 12.5602 +400 1 3.05453 18.3862 1.94671 -28.337 -27.777 -22.0693 +401 2 2.58101 17.7651 1.32015 15.7039 17.8808 20.6311 +402 2 2.35293 0.259745 2.36363 3.01847 1.93426 2.5363 +403 1 7.98344 1.63895 4.58298 -1.95289 -5.65456 5.83277 +404 2 7.39472 2.00993 3.91227 5.60846 -0.877805 -3.34347 +405 2 8.83104 1.39808 4.18815 -5.23209 5.3786 -4.6966 +406 1 2.44155 14.16 17.683 19.8901 20.6744 -11.1998 +407 2 1.71949 13.6284 17.9614 -19.7639 -16.6874 11.6615 +408 2 3.22651 13.6749 17.9404 10.3416 -4.56611 4.09925 +409 1 0.874431 1.8172 13.9017 -2.66591 2.98819 0.0720706 +410 2 0.796895 1.67216 14.8604 0.805718 -0.9226 -9.7327 +411 2 18.6311 1.96655 13.5402 2.6832 0.103556 9.2189 +412 1 4.40474 18.7103 13.8903 -4.51489 2.73844 -3.11833 +413 2 5.26066 18.332 13.6843 10.2731 -0.629088 3.90858 +414 2 4.27285 18.5624 14.8326 -2.10334 -1.04281 2.89108 +415 1 7.22541 0.768378 18.3802 -7.41292 5.22253 -10.0414 +416 2 7.14919 0.357851 17.5011 6.06274 3.8916 10.097 +417 2 6.39657 1.25171 18.5223 1.70256 -10.1891 2.75464 +418 1 16.0038 18.3833 13.9769 4.60778 -2.90009 -16.1733 +419 2 15.0678 18.3553 13.7682 -2.12799 2.80836 4.60244 +420 2 16.1189 18.6995 14.8699 -6.8859 -1.5785 15.9997 +421 1 10.1619 4.59436 16.2508 34.7775 -10.6887 1.26028 +422 2 11.1678 4.58362 16.2281 -36.3206 4.79489 -1.20103 +423 2 9.8959 3.67942 16.0718 3.3051 4.94693 0.644026 +424 1 15.9268 17.7185 4.48585 -0.443376 -19.9814 -7.77196 +425 2 16.5546 -0.221465 4.56619 12.2284 16.6263 -2.03126 +426 2 15.0862 18.0786 4.73637 -15.899 7.019 6.15678 +427 1 6.9987 17.4508 13.864 -28.5259 -4.03497 -9.84039 +428 2 7.52153 17.7102 14.6061 10.1765 7.77338 18.9538 +429 2 7.63162 17.2858 13.1766 11.9873 -1.11294 -13.1093 +430 1 13.256 6.47431 6.57718 13.0919 -2.27803 2.33044 +431 2 14.2181 6.68617 6.52776 -23.2683 -1.75779 -6.09518 +432 2 12.9031 6.34478 5.6793 8.47748 2.51219 6.97161 +433 1 7.82324 2.30197 9.35649 6.58131 4.23212 14.3466 +434 2 7.32826 2.17284 10.185 -1.16662 2.6949 -8.43976 +435 2 7.24342 2.0875 8.62812 -8.03625 -5.88123 -5.84644 +436 1 15.1686 14.8419 13.6961 6.6084 -8.9126 -6.67367 +437 2 14.8499 15.0658 14.5674 -3.29174 5.55862 10.3748 +438 2 14.9102 15.5355 13.091 -7.311 3.85237 -1.87114 +439 1 9.39203 8.3247 3.79765 -11.0731 4.19637 -5.3616 +440 2 10.2213 8.76913 3.95172 10.5135 8.75123 3.89829 +441 2 9.56922 7.39926 3.9554 -1.92777 -9.54221 1.11885 +442 1 17.7628 13.6056 16.4368 0.454101 -14.0132 9.10192 +443 2 16.8123 13.4442 16.4542 -1.43638 -1.23592 -2.30674 +444 2 17.8812 14.4042 15.9249 -1.89469 7.90276 -3.85648 +445 1 4.90818 10.546 2.83916 0.136377 -2.73925 -10.4847 +446 2 5.60998 10.1288 3.34488 4.96678 -0.616571 0.115447 +447 2 4.51664 11.1769 3.44738 0.912314 1.46625 2.09919 +448 1 3.71104 8.38719 10.068 0.753133 0.0228827 -3.76935 +449 2 3.89927 9.29887 9.80067 -2.70003 -3.09285 3.15772 +450 2 3.67512 8.396 11.0298 -2.24059 1.87779 0.37074 +451 1 15.9565 6.94095 5.99865 -8.76526 9.77307 4.96327 +452 2 16.7516 7.41234 6.24421 7.68049 3.9133 2.85915 +453 2 16.2393 6.06165 5.75492 3.70751 -7.34759 -2.0072 +454 1 15.1339 7.14501 9.07066 -1.17949 -23.8082 27.0602 +455 2 15.8283 7.58235 9.55517 11.4438 5.0236 10.3868 +456 2 15.1116 7.57875 8.25013 -4.20744 20.1878 -38.3409 +457 1 6.25297 12.9267 12.7452 -4.72449 1.01458 -5.57239 +458 2 6.98991 12.3599 12.9819 6.62509 -1.61272 7.49964 +459 2 6.12032 13.5727 13.4468 2.47956 2.45399 3.39123 +460 1 12.1116 4.51066 13.1059 -15.4407 -10.6836 -10.9314 +461 2 12.4271 4.59486 14.0171 -10.4637 -2.65404 1.19035 +462 2 11.2547 4.00523 13.0473 26.1752 13.1928 8.83048 +463 1 11.3958 8.13336 7.91828 -4.43196 -2.05658 -14.2843 +464 2 11.9753 7.54394 7.4184 3.39578 1.92795 -0.521112 +465 2 11.8257 8.23937 8.76441 1.22007 0.905858 11.3028 +466 1 17.1296 10.8754 7.54699 -15.2323 -0.655909 3.97588 +467 2 17.811 10.2663 7.31344 17.8297 -18.4071 -0.448075 +468 2 16.9935 11.379 6.74844 -4.7697 12.6356 -6.62113 +469 1 5.29547 18.1363 10.9421 18.5805 -0.935137 -5.10578 +470 2 4.88577 17.8485 11.7431 -9.76906 -7.6723 14.1577 +471 2 4.62403 18.0611 10.2783 -13.9129 1.88822 -17.2145 +472 1 7.59234 17.5076 1.75687 4.86523 1.07577 -14.9702 +473 2 8.00304 16.7666 1.28453 -8.52174 0.253094 2.89961 +474 2 7.35564 18.1425 1.05706 3.89665 -2.44167 8.83688 +475 1 1.92302 12.8778 13.5789 2.91886 3.94981 -7.24471 +476 2 1.45818 12.4106 14.2651 -5.47786 -10.2367 6.99308 +477 2 2.33812 13.6191 14.0211 -0.459782 9.91978 4.14062 +478 1 9.50973 6.75636 14.7983 0.267759 -13.8501 3.13598 +479 2 9.76861 5.87974 15.1842 -3.78976 20.025 -16.8859 +480 2 9.67323 6.78366 13.8359 6.07296 -1.5477 12.5306 +481 1 15.3007 4.25662 10.7816 1.6835 6.93604 -0.852744 +482 2 16.2201 3.94716 10.8841 -13.758 11.9338 1.00514 +483 2 15.2044 5.07319 11.3041 5.68258 -12.2185 -1.66994 +484 1 11.2682 6.20917 0.148653 5.11845 2.03204 -0.614283 +485 2 11.4613 5.3156 18.5351 10.8417 -13.6045 -1.35957 +486 2 10.3344 6.26425 -0.02153 -13.2524 10.0913 1.35666 +487 1 -0.0515508 11.3921 15.0043 28.8186 -12.3739 35.7691 +488 2 18.1888 11.7008 14.2289 -27.1505 12.4881 -39.8426 +489 2 -0.144753 12.1488 15.5889 -3.39882 3.34168 7.51926 +490 1 7.01363 9.26741 7.30523 1.11866 9.50703 -8.15996 +491 2 6.64493 8.42979 7.58084 -4.10674 -7.85165 7.60391 +492 2 7.94964 9.11568 7.16987 5.72986 -2.82238 2.51511 +493 1 18.3266 15.3189 12.3109 1.98396 7.8422 -1.62162 +494 2 0.557814 15.686 12.1521 7.34904 -2.57966 -0.481227 +495 2 17.7488 15.821 11.7275 -2.3238 -0.409324 -3.46342 +496 1 16.5074 4.41847 5.29023 -12.2776 2.5176 -39.1335 +497 2 16.8214 4.00292 6.06235 10.453 -12.003 36.2431 +498 2 17.1989 4.29433 4.62557 3.70164 8.40848 3.22117 +499 1 17.7062 3.18115 10.7633 -10.0415 -0.498888 0.968384 +500 2 18.5829 3.451 11.0307 13.8857 -2.29821 0.377097 +501 2 17.7544 2.33603 10.3089 5.51555 -4.87272 -1.50428 +502 1 12.31 -0.0249004 10.0958 7.06597 -29.3992 -7.90418 +503 2 11.4091 0.228435 10.2265 -21.0592 11.9526 6.39906 +504 2 12.8361 0.735194 10.2786 15.1995 22.0824 4.66414 +505 1 10.3672 9.76964 12.4555 1.27225 -3.68083 -7.54967 +506 2 11.1341 9.82258 13.035 0.839453 -0.704743 2.83749 +507 2 10.2702 8.82174 12.2801 -0.554943 5.543 3.04928 +508 1 0.65465 2.77798 7.04528 -2.13863 -3.2199 7.00126 +509 2 0.891211 3.42266 7.72053 -0.0150652 2.55779 -0.825415 +510 2 0.990123 1.95336 7.40694 -1.54003 -2.33595 0.508806 +511 1 0.295674 15.3348 6.84982 -3.22172 27.5014 26.3495 +512 2 0.521244 15.1551 7.76985 -0.748412 3.60522 3.47657 +513 2 0.484365 14.5358 6.4159 11.6769 -37.1534 -21.5269 +514 1 17.0573 6.99129 15.1128 -10.0859 0.519269 -2.81001 +515 2 17.7626 7.64158 14.9811 2.36054 -7.88383 3.70046 +516 2 17.4128 6.20418 15.5441 6.5971 2.49163 -1.29874 +517 1 9.10445 12.4501 8.04005 25.0355 12.8023 20.768 +518 2 9.46092 11.7782 7.45434 -7.91968 -3.65307 -8.74082 +519 2 8.16829 12.5393 7.95206 -19.3694 -6.70788 -7.44718 +520 1 1.22811 1.76814 2.9182 -6.11732 -10.0295 -0.237983 +521 2 0.712195 2.08081 2.16479 2.12402 6.69579 0.750032 +522 2 1.58605 2.52034 3.3947 3.99278 5.86411 -0.360805 +523 1 4.10894 15.0956 9.93451 6.69744 -1.75099 -1.18621 +524 2 3.96901 15.3261 9.00671 4.91376 -1.44666 0.188494 +525 2 5.04659 14.871 10.0423 -6.23862 1.0691 -5.37016 +526 1 7.35274 2.18983 14.6875 -7.358 8.13743 -4.11606 +527 2 7.08638 1.65776 13.9297 0.32385 -1.91134 2.32143 +528 2 7.57979 3.04743 14.3014 5.83731 -4.25907 3.58957 +529 1 18.4915 14.5922 2.16266 -14.7631 20.4811 3.31696 +530 2 0.685462 15.0501 2.31645 0.801171 -7.89169 -2.84158 +531 2 17.8141 15.3012 2.20781 8.07106 -12.7893 -1.48401 +532 1 9.99475 2.73128 12.8993 -0.14498 6.34622 4.34107 +533 2 9.94968 2.10764 12.1674 -2.02697 0.25981 -1.25528 +534 2 9.23805 3.32791 12.8055 1.37719 -5.85529 0.104676 +535 1 2.96937 8.88969 13.0348 8.45161 15.4602 -1.6792 +536 2 3.19044 9.8379 12.866 -0.537566 -21.2484 3.2835 +537 2 3.7799 8.47356 13.3849 -14.589 3.50084 -4.12479 +538 1 3.21 8.56161 3.75492 -0.42537 -8.47878 -37.7314 +539 2 3.66747 9.30861 3.32521 -2.76458 -7.90594 7.43156 +540 2 3.22415 8.6869 4.6856 3.07128 8.62247 25.8231 +541 1 5.62342 7.20688 8.60781 8.60088 8.53717 -11.0276 +542 2 5.53536 6.26871 8.41561 -2.891 -1.4677 7.62716 +543 2 4.92494 7.48858 9.21156 2.86443 -6.54236 0.635755 +544 1 14.9008 1.47426 1.89198 -2.54888 27.9205 4.61998 +545 2 14.5535 2.29499 2.28075 -2.57285 -15.9361 9.92214 +546 2 15.4844 1.8547 1.23467 3.18874 -15.0862 -12.382 +547 1 8.48736 15.1158 0.783841 -1.15568 2.93173 4.22404 +548 2 9.1238 15.1934 1.5071 4.62293 -5.62872 -5.40551 +549 2 7.79285 14.5509 1.14844 -2.73481 2.50701 -2.31707 +550 1 15.539 1.37952 7.19688 19.4515 3.6409 9.83231 +551 2 14.9389 0.78101 6.7773 -13.8468 -10.3512 -10.8641 +552 2 15.0003 2.07296 7.57775 -6.55979 11.3773 -1.03994 +553 1 5.01034 12.9912 18.4705 -11.9235 -4.12885 0.570622 +554 2 5.4698 12.9987 0.669061 0.312037 0.832023 7.43214 +555 2 5.59011 13.4721 17.8825 4.88062 -0.262691 -5.03625 +556 1 15.3764 8.57785 18.0866 -6.62354 -11.676 10.0569 +557 2 15.6805 9.14973 17.3909 9.52323 10.3388 -11.2321 +558 2 15.2475 9.1488 0.206008 -1.03261 3.33477 1.75561 +559 1 12.066 3.08414 18.3349 -10.3405 10.2428 -1.58162 +560 2 12.3601 2.47993 0.38654 4.70786 -1.39849 -7.75748 +561 2 12.2507 2.72995 17.4495 4.61736 -8.1861 15.8047 +562 1 13.1968 12.6883 5.15757 -0.336282 2.96846 2.60586 +563 2 13.7743 11.9999 4.79412 -5.71366 -0.326721 6.52296 +564 2 13.1697 12.5812 6.12031 6.45904 1.498 -4.43193 +565 1 6.0986 7.21596 0.138974 -12.0498 11.3036 0.237585 +566 2 5.91833 8.16028 -0.0709607 9.65884 -21.2748 10.0237 +567 2 5.34258 6.95155 0.690129 5.85049 -3.44248 -7.26534 +568 1 17.7044 15.8891 14.9714 -7.43083 8.66678 -26.2685 +569 2 16.7907 16.1885 14.8618 6.06094 -1.91119 12.6189 +570 2 17.95 15.7638 14.036 5.46338 -3.82161 12.7361 +571 1 13.1509 0.939295 16.6327 -8.19033 8.72571 -1.54201 +572 2 14.0859 0.833936 16.7968 10.9207 -0.957234 5.29932 +573 2 12.8431 0.0418051 16.5014 -5.83506 -5.32332 -1.35137 +574 1 10.9522 14.5534 7.35938 -9.11436 -19.3925 22.6665 +575 2 10.1531 14.2304 7.85485 20.6615 9.00594 -18.4516 +576 2 11.6365 13.8859 7.56325 -5.91964 10.2955 -7.71128 +577 1 17.5919 8.49388 2.10024 -0.0322199 -9.95032 2.76416 +578 2 16.7206 8.43914 2.53345 10.0393 -1.69965 -6.58888 +579 2 17.6862 7.68098 1.5623 -5.40062 15.1321 4.16518 +580 1 12.403 7.83298 1.98454 10.1699 2.43182 8.97059 +581 2 11.823 8.58837 2.10452 -0.914469 2.41145 -5.63632 +582 2 12.0432 7.27751 1.28772 -5.41827 0.0907324 -1.12401 +583 1 12.0169 14.6214 10.4613 22.6496 -4.80377 11.9203 +584 2 12.2953 14.2566 9.62296 -0.627137 -3.48742 -6.53871 +585 2 11.0904 14.7922 10.4232 -26.4922 1.86569 -7.97999 +586 1 6.79945 6.92747 15.5042 -19.94 -13.6896 0.562857 +587 2 7.71181 6.85747 15.2524 19.187 5.43316 -2.40109 +588 2 6.75196 7.52139 16.2502 2.78602 4.81827 4.32857 +589 1 8.02489 4.54706 13.3799 -9.17747 17.7449 0.879178 +590 2 7.13549 4.71954 13.0119 14.9133 -0.721221 -4.30494 +591 2 8.45659 5.41872 13.4818 -10.582 -17.269 -1.29002 +592 1 13.3893 12.1928 14.3557 -6.07818 9.44403 7.21842 +593 2 12.9754 11.3343 14.2402 3.84433 -8.34325 -3.30791 +594 2 13.789 12.4346 13.5154 0.839467 -1.50598 -4.68274 +595 1 14.6037 9.51924 7.26293 11.3016 8.32374 8.02904 +596 2 15.4883 9.92697 7.3747 -13.533 -2.89904 3.77438 +597 2 14.03 9.85877 7.96896 6.22863 -2.20078 -8.30261 +598 1 12.724 16.8794 3.24165 4.36843 -29.0517 -11.6906 +599 2 12.9143 17.2056 4.10583 4.58985 8.72699 22.0136 +600 2 12.2764 17.5776 2.79705 -13.1015 20.2627 -13.4405 +601 1 1.027 7.08618 17.3856 17.8688 -9.35062 9.83545 +602 2 0.150845 7.20834 17.7372 -11.0357 -5.72224 6.2597 +603 2 1.04228 7.56687 16.5674 -0.430665 10.2682 -15.3686 +604 1 12.9047 4.96423 15.6783 -31.9319 9.90183 -0.420667 +605 2 13.6101 4.38571 15.8945 27.3027 -16.194 0.870052 +606 2 13.2534 5.85423 15.7473 6.89498 8.57473 1.28829 +607 1 2.36359 3.37095 5.13131 13.5367 -21.0772 -51.8355 +608 2 1.78827 3.18983 5.83511 -26.0337 -9.2034 36.1161 +609 2 2.76982 4.19309 5.31063 16.9607 33.0577 11.3338 +610 1 8.25673 11.0457 13.6214 -29.0742 18.4766 -42.051 +611 2 8.3505 10.9269 14.5387 12.3752 -9.07103 37.7912 +612 2 9.04494 10.7715 13.1556 11.3248 -9.59576 5.23465 +613 1 12.933 1.51857 13.2538 -7.42773 -10.5209 16.1392 +614 2 13.555 1.47666 12.536 9.8649 3.44918 -12.9241 +615 2 12.6435 2.43109 13.2999 -2.22529 4.34734 -4.74481 +616 1 6.5593 13.6321 2.14465 -6.91915 6.53865 -12.6846 +617 2 5.89828 13.9136 2.78341 -2.94652 3.12599 2.20918 +618 2 7.14809 13.061 2.63026 6.2374 -5.23981 3.14213 +619 1 15.8933 6.50668 12.6624 16.2584 4.45316 -6.00807 +620 2 16.3963 7.03445 12.007 -8.38894 -8.88658 12.5353 +621 2 16.4415 6.50555 13.4748 -12.028 3.27562 -10.9527 +622 1 16.7983 0.717045 9.56947 3.68169 11.9749 4.12436 +623 2 16.6133 18.4601 9.81273 2.15246 -18.3954 6.85595 +624 2 16.3759 0.833391 8.71872 -3.66349 3.7587 -11.8412 +625 1 6.14397 11.6556 8.30338 8.0817 56.4015 -2.32443 +626 2 5.40727 11.3941 8.82366 -25.1595 -10.6153 12.4164 +627 2 6.54205 10.8782 7.99323 17.2725 -41.4748 -11.5815 +628 1 2.81032 8.69956 0.356218 24.742 -6.25 8.21391 +629 2 2.27105 8.19016 18.4013 -14.5977 -1.17978 -6.66412 +630 2 2.29881 9.42159 0.72289 -11.078 1.63045 0.198871 +631 1 10.1064 10.4292 6.59515 -4.60438 -3.93729 0.830471 +632 2 10.5227 9.70923 7.07758 4.69601 -3.0134 2.20114 +633 2 10.434 10.3774 5.69507 4.10481 0.747976 -4.90006 +634 1 6.80466 15.7541 6.67201 6.06476 3.31695 -2.74514 +635 2 7.12474 16.199 7.46137 -2.48244 -3.95514 6.52968 +636 2 7.21004 16.2686 5.96286 -5.79252 -2.21211 -4.39766 +637 1 6.45958 12.986 5.74076 6.97467 7.4921 0.177054 +638 2 6.67553 13.8767 6.05203 0.11849 -2.56514 -0.0944634 +639 2 6.15828 12.5051 6.51647 -3.32664 -1.56183 1.61673 +640 1 16.774 12.5213 9.71798 -12.6143 2.89661 19.2402 +641 2 17.0082 11.8947 9.03708 5.67192 -3.35034 -8.73073 +642 2 17.3962 13.2453 9.69208 4.02202 2.48097 -6.52464 +643 1 6.17384 2.92225 2.79448 3.9775 16.0199 -22.3947 +644 2 6.54801 3.78326 2.49667 -7.94175 -14.5768 11.9424 +645 2 5.69703 2.59738 2.01124 2.48224 -4.95439 10.1002 +646 1 10.7977 3.13994 3.23713 3.9771 -4.26255 2.57443 +647 2 10.0782 3.73781 3.45741 -0.0760182 2.97522 -1.01161 +648 2 10.5069 2.61778 2.47973 -3.48459 4.35709 1.40724 +ITEM: TIMESTEP +70 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.80152 6.81783 17.9876 -13.1435 8.65537 6.0931 +2 2 7.93927 7.0215 18.3978 9.39494 -6.73756 -6.11522 +3 2 8.64173 6.15327 17.319 -1.79792 -4.8767 -3.2487 +4 1 0.159104 8.33212 6.75565 -1.75886 1.86255 -0.283403 +5 2 0.400553 7.98898 5.87058 -1.56937 3.6046 13.6337 +6 2 0.532733 7.75931 7.44677 0.588181 -1.3305 -10.9259 +7 1 8.56014 0.2064 6.86713 15.1827 -2.1442 1.30375 +8 2 9.48839 0.201881 6.58247 -8.47619 -0.963055 4.35965 +9 2 8.1657 0.891093 6.32874 -5.18544 5.82437 -2.7504 +10 1 6.48158 1.74839 11.7303 -5.73112 -6.99234 -4.49671 +11 2 5.77966 2.25139 12.1582 1.03612 1.63173 -0.79005 +12 2 6.04661 0.9684 11.3341 5.10627 10.6526 7.94811 +13 1 6.96595 5.58057 2.38836 1.68885 13.6464 8.05547 +14 2 6.50498 5.94206 3.17078 2.94101 -7.34901 -12.8293 +15 2 6.93975 6.29059 1.72807 -1.07971 -9.74986 0.444847 +16 1 16.2371 10.2379 16.1019 -30.9876 -7.62323 7.88585 +17 2 17.0175 10.5802 15.7054 20.7335 11.057 -7.58035 +18 2 15.6477 10.9912 16.2983 15.508 -10.4523 -2.02188 +19 1 10.7008 14.9379 2.28795 4.31472 -8.51672 3.50984 +20 2 10.6635 14.2367 2.95607 -1.08681 7.31624 0.965 +21 2 11.2207 15.6296 2.69467 3.48557 9.19098 3.66151 +22 1 17.1795 8.23023 10.7992 8.53416 -1.59534 -8.67541 +23 2 16.5643 8.83199 11.2261 -1.39923 4.26423 7.56567 +24 2 17.9421 8.77596 10.5426 -4.34729 -3.75626 -0.741474 +25 1 14.6688 15.978 16.4285 2.33326 -11.9168 -2.20454 +26 2 13.7825 16.2968 16.2522 -6.84331 1.16869 1.85073 +27 2 14.5784 15.3806 17.1932 6.40998 12.5602 -6.81985 +28 1 12.1084 13.347 0.550082 18.7888 -12.4001 5.31554 +29 2 11.808 13.4241 18.2861 -6.00468 7.05887 -5.4437 +30 2 11.724 14.0175 1.12482 -9.88619 2.03399 -6.75529 +31 1 9.30709 5.48775 3.90966 3.41698 -5.29876 17.2174 +32 2 8.77877 5.25688 4.68667 5.61339 2.83044 3.00189 +33 2 8.64592 5.55872 3.2299 -8.10772 2.16644 -16.0449 +34 1 1.64595 4.02425 11.592 -10.9656 22.1289 -13.9701 +35 2 1.60629 4.97108 11.8395 -0.824037 -11.4025 -3.90562 +36 2 2.20491 3.59841 12.2231 10.5337 -11.1868 16.6964 +37 1 2.06621 6.87149 8.22737 1.24172 3.77126 1.52806 +38 2 2.50304 7.30143 8.97949 -2.75541 -3.2118 -2.64013 +39 2 1.97282 5.93715 8.45613 -0.171499 4.52155 4.26063 +40 1 5.3374 4.4954 7.902 -9.99384 -2.48662 -4.40208 +41 2 5.3873 3.53885 7.92862 5.32096 -10.0353 0.506932 +42 2 4.78906 4.68538 7.13029 -0.632429 8.18831 0.496784 +43 1 3.33945 2.92164 17.4119 -9.04777 -8.0172 12.2496 +44 2 4.01569 3.37904 16.9228 10.8208 5.2633 -7.4392 +45 2 2.90871 3.59334 17.9575 0.609467 0.189965 -2.29637 +46 1 7.45919 5.40741 6.16401 6.01334 0.147035 -1.33637 +47 2 7.84933 5.9815 6.83711 3.51741 -4.84398 -5.3698 +48 2 7.00259 4.70355 6.63733 -2.11297 5.93299 1.70682 +49 1 9.81228 7.01862 12.0561 -1.06857 0.870105 -3.24483 +50 2 10.2542 6.3375 11.5392 -2.78202 1.90065 -0.0845581 +51 2 9.1292 7.39963 11.4807 2.35361 -4.5728 1.86322 +52 1 13.9947 3.68643 8.08173 -5.65395 18.5094 -17.1015 +53 2 13.7843 4.54079 7.64233 1.50666 -18.9 8.64197 +54 2 14.1479 3.8993 9.00085 4.5059 2.7709 6.99075 +55 1 4.5073 17.1442 3.93435 4.48768 -12.0008 8.39889 +56 2 5.39081 17.5321 3.92633 -2.26089 2.72179 -5.35255 +57 2 4.01543 17.3459 3.13072 5.98217 13.0117 -0.399635 +58 1 16.4079 16.585 10.4121 -12.3499 -1.91652 -12.9082 +59 2 15.5551 16.5364 10.8674 2.44262 -0.34105 -1.56006 +60 2 16.2254 16.2298 9.51738 1.66683 0.349555 15.5208 +61 1 1.97926 4.78245 0.194184 -7.72676 6.8376 3.32149 +62 2 2.28164 5.2243 0.992573 8.53964 -6.59001 3.21257 +63 2 1.76914 5.52567 18.27 -2.63275 2.53007 -9.16672 +64 1 11.4134 13.2491 16.3873 0.68902 5.27402 2.7566 +65 2 10.9787 12.3908 16.4988 0.445492 6.36744 -3.52589 +66 2 11.9797 13.161 15.6117 0.593117 -3.37138 0.847423 +67 1 10.1151 10.9818 16.8138 12.4788 0.931853 3.10073 +68 2 10.558 10.1255 16.7937 -4.12284 -0.882862 -0.541555 +69 2 9.18349 10.8105 16.7424 -13.6774 -3.43657 -1.9902 +70 1 11.7994 17.4667 13.4795 12.7765 -4.5476 -2.07039 +71 2 12.3346 16.8373 12.9682 -4.67996 5.77396 2.18605 +72 2 12.2169 18.3179 13.2967 -7.11407 5.85224 3.16387 +73 1 6.41771 9.40938 12.2612 -1.11473 -8.0868 -15.4525 +74 2 7.03744 9.07449 11.5759 -13.2083 9.2101 17.4474 +75 2 6.9295 9.8935 12.9066 11.874 3.71682 2.38348 +76 1 16.2958 12.8923 2.71536 -7.68956 9.05075 5.11912 +77 2 17.1057 13.405 2.60095 0.726983 -7.0699 -1.53932 +78 2 15.5966 13.5689 2.77432 5.93986 -8.84533 -0.161974 +79 1 0.748159 12.7086 5.88144 -10.9756 -4.32923 1.80334 +80 2 1.126 12.5118 5.01571 -4.75041 4.90571 -2.30818 +81 2 18.4243 12.6438 5.75836 11.281 1.67442 1.09101 +82 1 5.27578 16.4085 18.412 4.21131 -11.5608 4.53747 +83 2 5.56823 15.5611 18.0525 -2.79743 5.31701 -3.02359 +84 2 5.61546 16.4141 0.666595 -0.372752 7.00853 0.303479 +85 1 0.645783 7.7249 4.17395 -22.5174 -18.1833 12.2453 +86 2 0.0406635 8.03244 3.50183 -6.8254 3.26088 -7.40309 +87 2 1.47404 8.07846 3.91568 30.354 9.58108 -9.75695 +88 1 3.15689 8.99663 6.46784 -29.6014 22.5811 -11.1032 +89 2 3.73467 8.6187 7.10087 15.4493 -13.4368 20.8179 +90 2 2.24881 8.95158 6.82736 13.2955 -4.68481 -5.71698 +91 1 7.31562 10.4015 16.2316 3.59442 1.76188 5.73087 +92 2 6.55849 10.6763 15.7162 -1.33577 1.2968 -0.922241 +93 2 7.0153 10.388 17.1537 0.717273 -3.98644 -9.35278 +94 1 11.0545 0.930228 4.99952 5.57476 -3.06583 5.10436 +95 2 11.2493 1.80197 4.63341 -8.70362 -0.159614 -5.22362 +96 2 10.8601 0.352804 4.24475 -0.891787 5.80331 3.4075 +97 1 4.31226 2.88036 13.174 -5.147 13.5187 -3.07305 +98 2 4.38813 3.36721 14.0053 4.89736 -4.04185 -0.502489 +99 2 4.16611 1.96327 13.4122 -1.31506 -9.67947 3.52696 +100 1 8.44169 10.2311 1.79631 7.56357 -11.9838 -1.9735 +101 2 8.31668 10.8926 2.47474 -4.45102 7.488 6.50539 +102 2 8.68604 9.43265 2.286 -2.4935 0.872154 -3.30188 +103 1 10.3613 1.71229 15.5051 2.98347 -4.15867 -5.41234 +104 2 11.2858 1.47948 15.6006 4.17674 0.252173 3.54686 +105 2 10.224 1.77346 14.5485 -4.83776 4.02156 4.39256 +106 1 2.62824 12.9587 7.89058 0.896502 -11.3927 -2.22701 +107 2 3.24219 13.4607 7.34422 -0.123332 4.88452 0.659902 +108 2 1.95928 12.6032 7.2874 1.64097 5.4786 -0.796639 +109 1 3.80872 11.636 4.95037 -11.7682 3.18495 22.2339 +110 2 3.64598 10.9456 5.61445 0.836076 6.10931 -6.44063 +111 2 2.95096 11.8687 4.56439 8.15456 -6.07271 -3.548 +112 1 6.68955 14.4669 16.969 -3.81156 3.78561 -6.36768 +113 2 7.31157 15.1356 17.2607 6.01474 -1.04117 -0.64393 +114 2 6.3928 14.7335 16.0851 0.840242 -1.58899 4.15547 +115 1 14.2051 14.5083 3.2908 -7.03725 6.3674 -0.58292 +116 2 13.7783 15.3639 3.15563 1.95336 -1.87129 -0.261548 +117 2 13.7683 14.1355 4.06228 2.52608 -4.66484 0.961916 +118 1 8.56009 18.0702 16.0712 3.20396 -8.67406 4.91505 +119 2 9.14753 17.3445 16.2475 -6.34669 -24.466 3.58587 +120 2 9.1857 0.126611 16.1642 1.87484 33.3672 -8.78222 +121 1 4.70115 1.72624 4.89274 27.4793 -6.96303 -5.48355 +122 2 3.95894 2.26041 5.13304 -17.2548 11.1403 -0.356707 +123 2 5.27782 2.26423 4.3214 -9.62564 -3.87491 4.20048 +124 1 15.0192 12.5587 16.5123 21.7041 14.8698 31.7439 +125 2 14.5985 12.983 17.2917 0.468388 -8.58398 -21.4185 +126 2 14.4797 12.5149 15.7347 -25.1252 4.80555 -9.98379 +127 1 15.7034 18.4851 16.8595 11.2428 14.4774 5.40242 +128 2 16.3726 18.3616 17.5507 -1.30019 6.81093 -3.04699 +129 2 15.2229 17.666 16.8625 -3.30988 -17.6635 -4.60623 +130 1 1.33118 1.27529 16.6047 -9.4861 0.393225 2.74141 +131 2 2.17004 1.71925 16.7831 -4.45817 3.09534 0.768406 +132 2 0.687638 1.66877 17.2201 8.28198 -2.79213 -3.95818 +133 1 18.1871 4.40384 15.9188 -4.2246 -5.6904 -13.4727 +134 2 18.0103 3.84369 15.1415 2.73285 7.2293 11.0268 +135 2 0.486098 4.58175 15.924 0.765927 0.250404 0.0527718 +136 1 12.1931 17.0307 16.1573 -7.03075 -8.39993 15.6705 +137 2 11.4402 16.4961 16.4862 10.3932 12.5123 -4.95214 +138 2 12.1197 17.0939 15.2076 -10.1529 0.179256 -12.7611 +139 1 16.106 2.59107 18.2096 -1.1157 3.6739 1.58184 +140 2 15.8464 3.51014 18.3379 -6.23469 -2.00336 3.76026 +141 2 15.8431 2.36085 17.3192 0.233798 0.882779 -7.24243 +142 1 6.71273 13.8002 10.1277 -4.97427 -8.24119 9.58999 +143 2 6.56779 13.4217 11.0085 1.93353 6.26249 -2.22943 +144 2 6.54815 13.0587 9.53715 2.49444 0.869035 -6.59786 +145 1 10.1873 18.4315 2.70955 18.3562 4.9239 2.5593 +146 2 10.5434 0.318979 1.97838 -6.6136 -2.73616 6.22508 +147 2 9.38189 18.0459 2.39836 -17.7025 -5.54205 -6.95436 +148 1 3.04496 17.7072 6.14474 -26.0897 -13.5421 -17.7616 +149 2 2.15406 17.5302 5.73662 26.1077 6.8467 16.2169 +150 2 3.64192 17.5514 5.40101 1.03601 7.77362 4.67988 +151 1 12.6273 16.8318 7.93854 -11.3452 0.662957 5.12661 +152 2 11.8845 16.2201 7.89678 1.40738 -6.80959 -10.3945 +153 2 12.3926 17.3902 8.68441 7.00662 7.84172 2.34647 +154 1 14.8855 15.2416 8.18261 -13.4645 13.8861 12.0711 +155 2 14.0556 15.7424 8.32689 13.5062 -6.9847 -4.51651 +156 2 15.2561 15.6092 7.37576 4.4997 -5.95581 -2.20609 +157 1 17.7963 18.2323 0.313468 22.8316 -1.73762 -16.8861 +158 2 18.5551 17.7341 -0.0636659 -20.2187 -0.580139 11.9305 +159 2 18.2144 0.43747 0.484185 -10.4644 5.54896 5.21224 +160 1 0.772309 10.5133 1.37975 -10.1333 -30.1062 6.79594 +161 2 0.0813059 9.81759 1.5081 15.2254 18.695 2.54909 +162 2 0.385285 11.1613 0.797203 -0.976125 9.32481 -5.57513 +163 1 1.78018 12.2676 3.33949 2.15539 9.4235 -7.57379 +164 2 1.54035 11.6193 2.6706 -4.1225 -6.27654 2.3776 +165 2 2.05243 13.0385 2.81809 -2.70385 -1.96831 6.56166 +166 1 0.659925 17.2426 4.96586 -18.1386 9.04401 18.0738 +167 2 0.178596 18.0473 5.21064 6.21229 2.02654 -16.1731 +168 2 0.324647 16.6226 5.62628 12.0605 -8.44774 -8.6881 +169 1 1.10032 0.835558 9.36207 -6.74911 6.08386 15.0138 +170 2 1.34007 0.666464 10.2949 -2.02307 -2.81345 -10.1719 +171 2 0.1714 0.592543 9.31025 -1.22709 -3.40717 -2.54195 +172 1 16.7505 2.35163 13.3289 8.60057 15.8485 -12.5846 +173 2 16.88 2.58008 12.3859 -1.48994 0.98841 16.7513 +174 2 16.5792 1.4154 13.3346 -5.94985 -15.1034 2.43107 +175 1 2.68711 15.9094 12.0537 -2.04437 -0.129745 31.1177 +176 2 3.02052 15.4906 12.8711 -6.40464 9.26827 -14.3072 +177 2 3.17282 15.5129 11.3342 0.535683 -2.02659 -8.3952 +178 1 16.4208 15.6182 6.1352 -21.1289 -3.6799 -9.5135 +179 2 17.2955 15.5836 6.51556 8.3115 3.57969 -3.1518 +180 2 16.3537 16.3493 5.49765 5.76519 -7.13598 7.22522 +181 1 5.79664 5.13529 11.8088 -4.38676 10.3557 2.90642 +182 2 5.60006 6.00552 12.2032 -0.739769 -8.67447 -3.0914 +183 2 5.02307 4.59055 11.9941 4.66701 -2.35447 -0.0408817 +184 1 15.1607 4.87263 0.806669 16.5091 -1.57376 7.82361 +185 2 14.8955 4.71033 1.72542 2.63671 -2.24198 -6.9535 +186 2 14.4069 5.23734 0.370441 -15.2288 7.71764 -6.62645 +187 1 16.3977 16.3968 1.96949 3.68196 12.8197 -24.7966 +188 2 15.8359 16.7471 2.65913 3.23547 3.93446 11.4731 +189 2 16.7724 17.1777 1.4991 -6.44753 -16.1278 10.1249 +190 1 0.213933 4.82135 3.88253 -26.808 7.93653 -12.3623 +191 2 0.234051 5.77519 3.99531 2.75938 5.29795 -1.25016 +192 2 0.961943 4.50047 4.34745 23.7428 -13.1307 13.4767 +193 1 2.96019 15.0595 15.1256 -5.74802 5.98414 7.79678 +194 2 2.74143 14.6748 15.982 5.94976 -7.2483 0.528018 +195 2 2.64636 15.9627 15.2549 -2.4967 2.40481 -11.2251 +196 1 1.11613 14.6445 9.47707 24.3082 -3.71628 -27.1602 +197 2 1.83443 14.0608 9.11052 -24.4018 17.7336 11.9542 +198 2 0.662892 14.1245 10.1216 -3.75634 -10.5151 15.6601 +199 1 13.5123 16.5361 11.5209 14.3415 8.92342 18.194 +200 2 13.0624 17.3115 11.1648 -0.833334 -0.722864 -7.66511 +201 2 12.9752 15.7809 11.2867 -3.03575 -6.70349 -11.2125 +202 1 4.68996 1.46706 0.718872 11.9134 2.33738 12.4928 +203 2 4.09477 2.04355 0.241198 -5.36661 3.4607 -5.79099 +204 2 4.1604 0.969338 1.36347 2.85434 0.638429 -14.0321 +205 1 1.49954 18.563 11.8891 -5.50653 18.8512 6.56283 +206 2 1.44134 0.571379 12.6129 -0.0136494 -9.64138 -5.67935 +207 2 2.21117 17.97 12.1221 3.30859 -8.66659 1.78907 +208 1 11.4402 10.1273 4.0296 -14.1313 -2.26429 -1.73879 +209 2 11.5467 10.5306 3.16018 -4.20959 -0.177974 3.37558 +210 2 12.3237 10.0244 4.36159 16.2917 -0.468181 5.60308 +211 1 8.19952 12.1987 3.67367 7.5254 -0.929385 2.30686 +212 2 9.06593 12.5735 3.89529 -5.56433 -0.233543 6.4332 +213 2 7.60827 12.3201 4.43288 5.90715 0.804339 0.890554 +214 1 14.5695 4.00736 3.30806 -0.853883 -3.91237 -3.28064 +215 2 15.2428 4.12216 3.97778 4.83301 -0.192226 6.11595 +216 2 13.7947 4.43075 3.66998 -10.7695 5.18811 0.448659 +217 1 5.68852 1.65707 7.54168 28.123 23.6896 24.0894 +218 2 4.98915 1.23464 8.0079 -23.0977 -17.1785 12.6492 +219 2 5.54722 1.47278 6.63267 -9.12733 -3.0122 -32.3212 +220 1 17.8871 1.01837 4.84182 2.82015 7.71075 0.411156 +221 2 18.4334 1.54735 4.24341 -1.55475 -9.21419 -1.50179 +222 2 17.685 1.60385 5.57556 -2.0638 -1.04483 2.6292 +223 1 6.8166 9.34907 4.51783 5.09473 -9.82493 1.7662 +224 2 6.68916 9.48214 5.46541 0.845655 -0.0829088 -1.52267 +225 2 7.72677 9.02302 4.42297 -5.47106 2.64724 -1.23342 +226 1 2.52902 14.8001 2.0243 -5.93162 -1.84873 -28.2955 +227 2 3.33024 14.7833 2.53171 11.9325 -2.28831 13.4023 +228 2 2.81062 14.7362 1.08886 -6.14041 -0.158095 16.8135 +229 1 17.2862 12.9192 13.1313 -13.4327 18.0081 -1.69868 +230 2 16.3974 13.2513 13.3936 19.5241 -4.39437 -6.93828 +231 2 17.8009 13.724 12.9107 -8.95295 -13.2998 3.51907 +232 1 14.8818 10.557 1.42323 -17.5015 7.25829 9.68839 +233 2 15.2835 11.3752 1.77244 -3.15433 -10.3089 -2.91904 +234 2 13.933 10.5609 1.67153 21.0133 3.93252 -5.34474 +235 1 5.70173 6.62264 4.58284 3.01718 2.50499 1.71703 +236 2 5.75902 7.56019 4.39794 2.55817 9.91828 -0.0203224 +237 2 6.42399 6.43452 5.20085 -6.85011 -4.70646 -2.52597 +238 1 8.0341 8.36204 10.3892 10.4405 -6.77488 -14.8808 +239 2 8.6296 8.90948 9.85447 -2.74542 2.30932 7.48232 +240 2 7.64772 7.74454 9.75603 -3.95063 2.60786 3.00172 +241 1 13.4272 18.4528 5.67238 9.25795 -5.11499 9.49722 +242 2 12.7163 0.440246 5.56173 -10.019 1.98309 -6.96611 +243 2 13.1619 17.9514 6.45613 2.7128 -4.57063 -2.8 +244 1 -0.0270522 2.62208 0.316378 14.2494 -14.2567 4.73545 +245 2 17.7181 2.78355 18.7164 -19.3625 -8.86024 -5.69671 +246 2 0.361548 3.46719 0.160861 21.2807 17.6319 0.792983 +247 1 12.9304 10.9756 9.73287 -28.9199 -18.5822 3.85047 +248 2 11.9453 10.9259 9.78333 22.7984 8.3459 -7.73181 +249 2 13.1639 10.0723 9.99967 2.00349 4.19966 -2.07729 +250 1 0.632704 12.1509 11.1096 7.92792 10.2243 1.08862 +251 2 18.3238 12.1837 11.2671 1.30826 1.36738 8.17016 +252 2 1.12128 12.4175 11.9061 -11.5401 0.628467 -1.63311 +253 1 5.16172 7.34292 13.3779 5.89076 -0.786387 1.26512 +254 2 5.63913 8.13751 13.0818 -0.253704 -8.62988 -1.18816 +255 2 5.64992 7.00871 14.1461 -2.49218 7.71701 -3.25354 +256 1 1.18315 6.80996 11.9457 -21.1971 9.90527 -11.1777 +257 2 0.396163 7.2181 11.5121 19.4256 -12.5543 10.5539 +258 2 1.74685 7.55572 12.1675 3.51989 2.12142 1.71712 +259 1 15.5171 9.71047 12.3281 2.29457 -6.5479 -4.23973 +260 2 15.3017 10.6102 12.0519 -2.15799 -4.39765 10.01 +261 2 15.6816 9.70968 13.2745 -0.591496 3.33032 -0.321137 +262 1 16.5873 12.6729 5.56721 2.76163 -0.166181 -5.31991 +263 2 16.3773 13.5773 5.84608 0.225425 -0.965456 -7.72797 +264 2 16.4542 12.6253 4.60029 -0.729256 4.09093 10.083 +265 1 6.36605 9.79142 0.024922 -16.0501 18.8211 -0.426432 +266 2 5.53971 10.2677 0.213525 8.17613 -4.10964 1.60097 +267 2 6.98218 10.0336 0.714657 7.30358 2.91784 7.9977 +268 1 12.2857 6.09281 4.02237 -18.7873 -18.2554 10.8389 +269 2 12.2499 6.90248 3.51498 -0.180994 1.77121 -11.4426 +270 2 11.3769 5.71462 3.99073 18.6718 6.8659 -0.0124277 +271 1 0.371339 12.8581 0.116813 -11.2914 -0.881026 -5.3546 +272 2 18.6979 13.4634 0.798717 1.88955 0.580482 0.906428 +273 2 18.4407 13.0157 17.9982 0.051521 1.66817 1.81741 +274 1 3.57562 18.6672 8.63597 16.8652 -4.29809 -8.00937 +275 2 3.39672 18.3023 7.75382 0.438355 1.17547 6.33464 +276 2 2.72388 0.290377 8.97499 -6.05452 1.31479 -1.62581 +277 1 7.38199 17.3678 4.46374 -1.38292 15.3105 6.33947 +278 2 7.69148 18.255 4.75287 -6.89683 -17.7129 -9.79531 +279 2 7.51455 17.3077 3.50947 0.595015 4.11355 1.7546 +280 1 9.26329 17.1448 12.185 -8.64248 6.96454 5.63337 +281 2 9.31183 16.2501 11.845 1.80177 -5.78684 -3.53436 +282 2 9.93599 17.2354 12.8685 5.43729 -1.39148 -3.55242 +283 1 13.2821 13.1028 8.02698 11.8692 -15.3168 6.16039 +284 2 13.4688 12.3189 8.5813 -8.97739 12.1367 -7.14337 +285 2 14.105 13.618 8.04076 -8.38267 2.98351 0.0644509 +286 1 14.8025 2.98142 15.4294 17.4288 1.80056 -2.61073 +287 2 14.201 2.26032 15.2834 -13.2348 -7.60023 -2.35086 +288 2 15.3302 3.01554 14.6169 0.118996 0.402428 5.45631 +289 1 9.92493 15.6251 16.9821 6.00495 -5.53666 -0.13681 +290 2 10.4191 14.8506 16.6821 -3.27256 -3.64184 -5.012 +291 2 9.59076 15.3546 17.8439 -3.58917 5.2502 2.724 +292 1 11.2797 8.49868 16.6198 -1.73472 -6.52809 -3.79184 +293 2 10.75 7.88393 16.0952 -2.42874 5.03231 0.808132 +294 2 11.4092 8.05007 17.4587 2.82097 -1.86681 0.519814 +295 1 4.04678 18.2455 16.7988 -8.77416 25.1666 -6.65304 +296 2 4.65779 17.694 17.284 2.06605 -2.99109 10.2548 +297 2 3.96053 0.454509 17.276 5.60906 -19.8799 -5.16878 +298 1 2.27095 4.25175 8.91936 5.9784 -6.58712 9.82608 +299 2 3.2186 4.2524 8.72216 -4.79336 -1.38402 1.94738 +300 2 2.18112 3.96584 9.85003 1.09756 8.39619 -11.3917 +301 1 9.88624 10.3936 9.78011 6.22166 -2.86793 -13.7384 +302 2 9.62293 11.2772 9.51568 -5.75811 3.67729 -6.27375 +303 2 10.0642 10.4241 10.7104 0.548842 -0.969577 22.0405 +304 1 9.71663 0.937962 10.8586 -0.709221 -7.70358 -11.4846 +305 2 9.30987 0.134657 11.1937 5.18354 -4.14977 6.17978 +306 2 9.11908 1.1943 10.1452 4.37988 8.3302 1.85952 +307 1 9.18198 15.0956 10.1953 -4.26962 6.22766 7.58802 +308 2 8.89777 15.9846 9.95951 0.743088 2.4445 -7.53567 +309 2 8.34997 14.6032 10.2066 5.52748 -3.88041 -1.79992 +310 1 0.872205 9.70338 10.2435 26.5305 -15.7209 -40.6294 +311 2 0.885793 10.5746 10.6186 -2.04601 10.7115 5.01116 +312 2 1.5471 9.74995 9.50099 -28.1395 -6.59839 33.8889 +313 1 17.1072 4.85649 8.10795 10.9462 -15.5033 5.93553 +314 2 16.3968 5.45295 8.31142 -11.4282 10.1371 2.96807 +315 2 17.1775 4.27052 8.87929 1.82351 6.10377 -11.9311 +316 1 14.794 14.6968 0.0807509 -15.0506 -16.2211 -7.1198 +317 2 15.1293 15.3316 0.707575 7.57499 5.98458 11.2724 +318 2 13.942 14.3729 0.412504 5.92115 1.12787 4.02247 +319 1 3.8058 11.0463 9.54758 -4.72716 5.89465 -11.0149 +320 2 3.75265 11.4758 10.4012 1.08641 -1.46789 11.7249 +321 2 3.34125 11.6425 8.94232 1.4747 0.62014 0.836248 +322 1 11.3036 10.7395 1.51518 17.421 7.70001 -9.9965 +323 2 11.5572 11.5513 1.04939 0.916953 -2.49636 4.28379 +324 2 10.3663 10.6689 1.38091 -17.6315 -2.91035 -1.9437 +325 1 13.1498 7.19173 12.6392 -12.6781 -12.1868 5.62798 +326 2 14.0645 6.9093 12.7169 6.63809 2.55694 -2.55252 +327 2 12.6264 6.38473 12.8035 6.43409 8.48166 -2.8301 +328 1 9.6244 1.91603 0.948782 1.73007 4.87205 -17.2591 +329 2 8.78103 1.84907 0.47922 2.387 -4.26061 4.8929 +330 2 10.2561 2.20979 0.275304 -2.56753 1.91417 5.98087 +331 1 10.6541 13.4625 4.53479 -4.64228 5.78216 2.02785 +332 2 11.5543 13.1406 4.67483 -3.60366 -2.8444 3.58336 +333 2 10.4931 14.1115 5.23949 3.28752 -7.90473 -1.94244 +334 1 14.4847 1.66582 10.9548 -5.6847 9.24739 -2.41061 +335 2 15.2495 1.25185 10.5509 3.51804 0.734089 -1.48015 +336 2 14.6665 2.62215 10.9157 -2.44239 -9.64589 2.94827 +337 1 14.5153 12.0551 11.6598 -8.57838 4.331 1.02894 +338 2 15.2406 12.4341 11.1775 15.6624 8.75252 -5.54666 +339 2 13.8905 11.8145 10.9694 -5.00706 -1.53612 2.9308 +340 1 8.18805 5.09916 9.82303 -13.8101 6.02591 4.86356 +341 2 7.31243 5.14562 10.2589 14.5937 -0.354252 -5.27398 +342 2 8.2462 4.20505 9.47267 -0.0530366 -3.80538 1.315 +343 1 1.47125 16.9173 18.4665 17.3664 16.657 -21.1079 +344 2 1.9236 17.2269 17.6455 -9.65792 -6.20403 18.6505 +345 2 1.59593 15.9726 18.4726 0.464255 -9.97504 -1.82966 +346 1 1.48039 17.3287 15.3228 1.51401 14.0556 6.72393 +347 2 1.34693 18.2292 15.6575 8.56134 -5.76509 -0.66881 +348 2 0.596093 16.984 15.2507 -11.2139 -7.77617 -1.25224 +349 1 3.58273 5.77174 6.05172 -7.98503 -18.1926 7.56457 +350 2 3.04578 6.35459 6.60151 3.24577 3.33226 -0.333817 +351 2 4.18271 6.30655 5.53303 2.15541 4.89174 -3.71227 +352 1 12.4965 9.48476 14.2165 -0.670713 16.0192 -6.73881 +353 2 12.9556 8.76438 13.7775 2.07937 -6.9932 3.10842 +354 2 12.3436 9.22115 15.1264 1.05397 -7.72063 3.19376 +355 1 4.0654 15.2599 7.01126 14.536 -9.99762 3.77636 +356 2 3.57418 16.0458 6.77165 -4.77502 7.81332 -2.1228 +357 2 5.00035 15.4681 6.83264 -6.89866 -1.23873 3.67355 +358 1 0.723833 8.69198 15.0851 1.39297 0.947643 -5.33928 +359 2 0.438801 9.60781 15.1421 -2.06214 4.43911 1.45744 +360 2 1.38458 8.70272 14.3802 0.858615 -3.42768 2.38717 +361 1 12.8756 8.29184 10.1606 18.5084 -5.85873 3.08502 +362 2 13.7209 7.89345 9.85142 -16.8549 4.13316 8.30657 +363 2 12.7515 7.97965 11.0724 6.23426 1.04322 -7.42686 +364 1 15.3229 7.8277 3.50947 17.5558 22.7432 -34.5468 +365 2 14.4697 7.71438 3.07339 -7.31906 -8.87793 15.8657 +366 2 15.4806 7.65388 4.43399 -18.8005 -15.0751 11.2523 +367 1 17.2596 6.73529 0.0260639 -2.34928 8.60384 0.474092 +368 2 16.7705 6.01921 0.434638 -6.55856 -4.92879 -0.567585 +369 2 16.5991 7.41683 18.4475 3.41319 -8.53114 -0.808778 +370 1 8.95463 6.95692 7.78734 -12.7059 -4.64784 9.91199 +371 2 9.87027 7.23168 7.81087 8.51327 4.71948 -0.0600656 +372 2 8.83651 6.35153 8.53608 0.68522 0.961995 -1.89804 +373 1 12.4059 0.607414 1.26231 3.62116 2.02707 -9.0712 +374 2 13.2571 1.01103 1.48145 3.02509 -6.80244 -1.55076 +375 2 12.4394 0.42011 0.312768 1.30302 -0.072107 7.45087 +376 1 5.61221 15.1181 14.5069 21.81 1.56396 -5.03583 +377 2 4.69671 15.2613 14.7447 -7.9418 2.21424 1.99916 +378 2 6.02853 15.9808 14.3125 -8.14435 -8.16553 0.0834836 +379 1 3.81616 6.42663 1.71897 -4.74342 3.6354 -4.79161 +380 2 3.34042 7.16969 1.31421 3.65203 2.80462 3.7212 +381 2 3.89499 6.64183 2.65143 -2.11765 2.44111 2.19083 +382 1 3.90516 11.4598 12.3793 9.45586 -8.94044 -12.3546 +383 2 4.79548 11.8227 12.4942 -7.15738 -0.735807 -0.876075 +384 2 3.31554 12.0782 12.7961 -9.4854 7.67777 7.65311 +385 1 5.30665 3.87758 15.8091 -6.5654 14.2288 -0.0449474 +386 2 5.99806 3.22942 15.6938 11.0923 -7.17561 -6.6845 +387 2 5.74209 4.7421 15.8325 -0.91092 -4.98763 -0.535492 +388 1 14.1952 10.2038 4.61463 -6.5923 1.74463 -22.8561 +389 2 14.2343 9.86507 5.49824 4.23866 -7.49318 19.2708 +390 2 14.5963 9.53108 4.04607 2.17028 4.66107 2.75401 +391 1 7.63145 17.3499 9.0679 -5.43123 5.71002 -0.0698024 +392 2 6.89643 17.6949 9.58041 -2.21022 -5.88459 7.45639 +393 2 7.83827 18.0718 8.46746 8.40651 -1.69566 -7.5742 +394 1 4.52514 14.4769 3.85867 5.05038 7.53463 5.39007 +395 2 4.64261 15.388 4.18066 -3.91408 -9.29834 -6.31781 +396 2 4.46355 13.9264 4.6465 1.7827 -2.93555 -2.6265 +397 1 14.2493 7.38723 15.8586 4.87219 -5.15553 -0.709446 +398 2 15.1473 7.29965 15.5014 -5.21416 1.68161 3.76194 +399 2 14.3665 7.7773 16.7353 0.544226 -0.39761 -4.2243 +400 1 3.0581 18.4144 1.95119 -22.1859 -8.41359 7.65322 +401 2 2.57832 17.7386 1.43356 3.30075 12.2585 2.4632 +402 2 2.38613 0.281938 2.45339 8.18993 -10.3808 -10.0068 +403 1 7.97435 1.63455 4.58282 23.9975 -9.20271 -17.826 +404 2 7.40194 1.94347 3.87976 -9.32013 4.13397 -1.27928 +405 2 8.80392 1.4125 4.10448 -12.4762 5.5818 15.8983 +406 1 2.4378 14.1623 17.6894 -3.94912 5.20331 -2.53114 +407 2 1.6661 13.615 17.8755 3.58117 1.8004 4.78536 +408 2 3.18519 13.6404 17.9779 13.28 -5.73443 1.82606 +409 1 0.901685 1.86492 13.8925 12.6905 0.691236 2.76957 +410 2 0.97461 1.67681 14.8348 2.02403 -0.73996 0.457614 +411 2 -0.0244921 1.99897 13.7259 -14.1961 2.08272 -4.4518 +412 1 4.37872 0.0904002 13.8777 13.1739 1.11326 -7.50903 +413 2 5.30332 18.4699 13.7308 -6.52685 1.52196 1.48666 +414 2 4.22979 18.5754 14.8098 -5.10379 -2.3914 9.04502 +415 1 7.27651 0.845893 18.3957 -16.6762 17.2151 26.568 +416 2 7.1678 0.492927 17.521 -0.448362 -6.22938 -12.6047 +417 2 6.39207 1.1517 18.718 17.8505 -10.612 -11.3067 +418 1 15.9607 18.375 13.9642 -35.6371 5.35013 -16.5011 +419 2 15.0008 18.4642 13.7578 26.2499 -2.51915 -0.30366 +420 2 16.0214 0.00880953 14.871 6.50934 -2.46523 19.0717 +421 1 10.2176 4.60873 16.2514 5.45645 -16.296 -9.2455 +422 2 11.1834 4.4434 16.3559 -20.4013 6.80033 -5.0518 +423 2 9.84346 3.80184 15.8357 11.7075 10.859 12.3241 +424 1 15.9288 17.6854 4.49702 -25.8895 1.84686 -2.2825 +425 2 16.5611 18.3979 4.49336 8.57016 10.0602 -1.14853 +426 2 15.0697 18.092 4.72548 12.7214 -6.58434 0.45321 +427 1 6.97646 17.4765 13.8835 1.51347 6.32825 6.74987 +428 2 7.46829 17.7625 14.676 -2.92413 -3.08896 -9.25103 +429 2 7.63479 17.4162 13.1781 -0.793447 -1.23312 2.0982 +430 1 13.2369 6.46193 6.55272 7.97686 -7.07829 -14.9633 +431 2 14.2045 6.47863 6.50403 -7.11621 7.88379 2.07663 +432 2 12.9571 6.40302 5.61769 -2.27464 -2.27743 14.9713 +433 1 7.84752 2.28013 9.41028 -8.73892 -0.731414 -17.5278 +434 2 7.29261 2.26329 10.1936 -2.39479 -1.12016 7.77392 +435 2 7.27021 1.99883 8.67538 7.42107 2.89864 6.55304 +436 1 15.163 14.8378 13.7075 -5.08255 6.9114 -1.94911 +437 2 14.828 14.9803 14.5966 0.517852 0.790599 5.03408 +438 2 14.8205 15.5736 13.1818 1.46712 -6.90646 -0.613497 +439 1 9.40195 8.33905 3.81803 -16.6236 -1.1153 -3.723 +440 2 10.1861 8.88666 3.81624 11.7714 1.21262 5.85608 +441 2 9.65895 7.42947 4.01423 -0.646232 2.08147 -2.76231 +442 1 17.7496 13.6056 16.4496 1.61536 7.2683 -6.30775 +443 2 16.7925 13.5164 16.4445 -3.33508 -5.74033 1.31806 +444 2 17.9176 14.3949 15.9026 -1.24178 -7.25826 8.29135 +445 1 4.89231 10.51 2.8606 23.2586 -26.6571 -20.5821 +446 2 5.63741 10.0083 3.24852 -7.78968 12.4235 -4.83768 +447 2 4.54582 11.03 3.56787 -4.03679 11.8248 12.8852 +448 1 3.69823 8.4002 10.0127 -3.60192 -11.2793 13.5005 +449 2 3.83759 9.3113 9.76164 0.279778 8.83932 -1.11316 +450 2 3.64192 8.42085 10.9836 -1.53751 -1.28356 -9.75822 +451 1 15.9467 6.92332 5.94112 11.8737 -8.24502 3.37919 +452 2 16.7476 7.39494 6.19571 -0.497479 1.69122 3.51528 +453 2 16.2467 6.02535 5.70675 -5.68891 13.7396 -0.851978 +454 1 15.1658 7.18492 9.0507 -10.4703 -15.8706 0.47552 +455 2 15.9236 7.59272 9.46168 11.862 8.93317 3.67812 +456 2 14.9906 7.60382 8.20629 4.02444 8.70872 -4.23998 +457 1 6.21618 12.8841 12.7284 -3.21766 12.2709 11.5322 +458 2 6.77909 12.207 13.0973 14.7659 -5.65099 1.01901 +459 2 6.15827 13.5741 13.4151 -3.2657 -3.93324 -9.28774 +460 1 12.1165 4.51288 13.1048 -1.62418 -0.0716723 20.7898 +461 2 12.3817 4.58382 14.0419 2.18295 3.85449 -11.1604 +462 2 11.2475 4.10019 13.1569 -0.321339 -3.45694 -9.73345 +463 1 11.4166 8.11249 7.92599 8.37678 -3.86112 -10.8327 +464 2 12.0468 7.60844 7.37796 -5.38848 4.21425 7.2331 +465 2 11.8428 8.18692 8.79136 -5.59584 -0.0130509 -4.24997 +466 1 17.091 10.8655 7.57222 -5.5019 -10.6926 10.9756 +467 2 17.8562 10.3128 7.37833 -2.02493 -0.998523 -7.2616 +468 2 16.8515 11.3839 6.80089 6.08197 4.8342 -8.48749 +469 1 5.2937 18.1227 10.8823 3.58086 -4.72457 -4.80722 +470 2 4.89277 17.7527 11.67 -2.28546 -3.10604 1.32943 +471 2 4.67512 17.9479 10.167 -5.31481 4.288 -3.34371 +472 1 7.59808 17.4966 1.71058 0.398559 1.64094 13.9409 +473 2 7.8828 16.705 1.25288 5.11743 -4.18927 -7.63945 +474 2 7.62118 18.2252 1.08608 -3.03358 1.0728 -8.8916 +475 1 1.91712 12.8862 13.5909 8.98798 9.32187 -3.03347 +476 2 1.48166 12.3531 14.2581 -2.09819 -2.06604 3.51643 +477 2 2.30811 13.6552 14.041 -7.16378 -5.11315 -1.13098 +478 1 9.42828 6.75322 14.7826 20.1915 -11.5504 -11.1057 +479 2 9.8277 5.94835 15.1588 -6.88663 6.02054 3.69259 +480 2 9.80073 6.79406 13.8821 -8.1098 8.28496 9.35183 +481 1 15.2968 4.25709 10.7854 2.83104 8.23395 -4.89519 +482 2 16.2313 4.08269 10.6128 -5.94582 -2.20316 7.08238 +483 2 15.3124 5.02999 11.3646 -3.5924 -3.42311 1.83328 +484 1 11.2927 6.22318 0.123361 12.5475 12.622 0.859144 +485 2 11.5233 5.29113 18.7512 -7.74436 -5.44097 -5.24926 +486 2 10.3808 6.34995 18.4806 -0.327163 -9.85792 5.03233 +487 1 18.5472 11.423 14.9732 18.3726 -20.3084 16.0571 +488 2 18.105 11.7915 14.2257 -13.2839 12.4126 -20.1368 +489 2 18.4564 12.0929 15.6514 -4.79118 8.10765 5.85542 +490 1 7.00881 9.27577 7.32015 -11.3868 -9.38104 -0.512081 +491 2 6.68278 8.41602 7.64312 1.53223 10.0212 -0.264373 +492 2 7.94615 9.16913 7.19167 13.4366 -2.83724 0.374421 +493 1 18.3388 15.3149 12.278 7.79295 4.11927 0.907342 +494 2 0.562248 15.7272 12.1255 -3.32497 -4.13752 -3.12696 +495 2 17.7171 15.7348 11.6722 2.18188 4.14775 -1.5511 +496 1 16.4968 4.40066 5.28798 -9.94208 -5.06851 -0.773295 +497 2 16.7853 4.2225 6.18546 2.9967 -3.39819 7.99443 +498 2 17.2662 4.33461 4.72457 15.1936 4.75592 -3.34352 +499 1 17.7173 3.18772 10.7866 10.4448 7.42964 -1.18609 +500 2 18.6422 3.37989 10.9855 -1.52891 3.674 4.44234 +501 2 17.7488 2.39891 10.2588 -4.04978 -15.6839 -7.32077 +502 1 12.3149 18.6145 10.0881 -2.22129 4.11252 3.54852 +503 2 11.4444 0.333084 10.2939 -3.02626 -1.86973 1.00626 +504 2 12.9201 0.705852 10.2372 4.71846 0.03299 -1.96706 +505 1 10.3684 9.76179 12.4758 17.9734 4.74974 2.50525 +506 2 11.1916 9.84607 12.9926 -11.8304 0.187235 -1.96375 +507 2 10.3012 8.81681 12.3218 -3.77483 -3.01576 0.0814472 +508 1 0.689392 2.74058 7.08104 -5.98449 10.1616 9.8561 +509 2 0.88859 3.44563 7.72485 0.581102 -9.26818 -8.93017 +510 2 0.974446 1.93578 7.5088 2.3916 -6.77547 7.05728 +511 1 0.277472 15.3259 6.84135 0.228059 -1.31559 -11.5462 +512 2 0.516029 15.5821 7.71821 6.50181 -1.47438 23.8891 +513 2 0.58839 14.4222 6.74639 0.679055 -1.95969 -5.2972 +514 1 17.0529 6.97528 15.0633 10.9144 -7.53558 1.72506 +515 2 17.8201 7.55974 14.9678 -6.11827 1.26888 -1.51964 +516 2 17.4266 6.16431 15.4413 -5.39729 2.11926 -0.659196 +517 1 9.11957 12.4732 8.03484 -32.1356 7.88594 4.6652 +518 2 9.41535 11.8783 7.35952 15.5672 -13.5118 -9.19924 +519 2 8.15954 12.512 7.86156 14.5216 4.72308 9.92056 +520 1 1.18275 1.7303 2.88012 3.13258 6.74516 -6.07855 +521 2 0.990874 2.23802 2.08159 -8.2151 -5.8717 0.0306137 +522 2 1.74436 2.31191 3.39299 4.34337 2.29394 9.11202 +523 1 4.11863 15.0886 9.98721 11.0177 -1.77256 -13.134 +524 2 4.02022 15.2012 9.03136 -3.58336 0.815549 3.23991 +525 2 5.04995 14.8741 10.1041 0.462863 -2.8957 0.615957 +526 1 7.38268 2.21023 14.7219 2.37064 11.9314 4.06902 +527 2 7.04717 1.62795 14.04 0.302375 -0.796384 -5.36483 +528 2 7.78873 2.97247 14.2654 -8.69617 -12.215 6.09363 +529 1 18.4343 14.5687 2.16054 8.35658 -0.618946 0.782777 +530 2 0.682906 14.919 2.34098 -12.2336 -1.59186 -0.620803 +531 2 17.7977 15.2902 2.22089 3.32879 4.73949 -0.959115 +532 1 10.0087 2.72001 12.9057 2.08485 -1.52945 -12.9938 +533 2 10.0412 2.17732 12.096 -1.38389 3.39971 12.264 +534 2 9.25575 3.30628 12.7713 -2.15732 -0.406341 3.704 +535 1 2.9831 8.88024 13.0189 0.952466 11.8173 -3.08609 +536 2 3.31938 9.77893 12.8076 -5.04245 -14.2298 4.61688 +537 2 3.71596 8.41411 13.4449 -4.1112 -0.429279 -5.2011 +538 1 3.20203 8.5912 3.76846 -11.4045 -12.6583 26.9753 +539 2 3.76961 9.22975 3.3591 6.50161 14.1888 -13.0281 +540 2 3.15464 8.85629 4.71231 4.40411 -9.17072 -19.7321 +541 1 5.64764 7.22249 8.60582 -2.45044 -0.628932 2.27153 +542 2 5.55364 6.27099 8.49955 3.15339 -1.29251 -2.67256 +543 2 4.90409 7.47651 9.17344 9.24373 2.45699 -1.73114 +544 1 14.907 1.53023 1.85078 -7.37767 -15.1485 8.29721 +545 2 14.668 2.24872 2.45072 11.5035 7.56218 -5.89301 +546 2 15.6059 1.77377 1.2289 -9.91057 9.46649 1.95684 +547 1 8.55561 15.0845 0.759561 -2.78586 4.97755 1.3099 +548 2 9.2232 15.1059 1.46635 -5.75771 -3.12613 -8.68727 +549 2 7.79979 14.5909 1.11068 3.03755 -1.08449 1.22088 +550 1 15.5064 1.39564 7.20176 -2.04619 -6.07348 -4.735 +551 2 14.846 0.870461 6.73047 4.3658 -0.949999 1.00211 +552 2 15.0733 2.23713 7.35024 -3.19526 7.79987 5.63196 +553 1 4.99693 12.9582 18.4618 -8.43591 -3.95032 12.7964 +554 2 5.427 12.9558 0.691187 -3.21166 1.68806 -6.66553 +555 2 5.5701 13.4759 17.8974 6.4766 -1.03013 -3.5001 +556 1 15.3823 8.61159 18.0651 4.42877 2.22092 -6.07372 +557 2 15.8154 9.23321 17.4587 -2.51695 -7.00562 1.90652 +558 2 15.1591 9.14089 0.186524 -1.03798 5.78876 7.10622 +559 1 12.0334 3.10844 18.3299 11.3082 -20.8993 7.10454 +560 2 12.3341 2.61645 0.471712 -7.66483 12.171 -5.21514 +561 2 12.3614 2.54753 17.6085 -4.58122 9.25845 0.807451 +562 1 13.192 12.7001 5.16537 5.21593 -6.7049 -2.26257 +563 2 13.6127 11.9331 4.74049 -3.39065 6.67562 5.25333 +564 2 13.2679 12.5364 6.11315 0.126366 6.17512 0.133491 +565 1 6.11282 7.21918 0.158665 1.88014 -14.5403 11.0752 +566 2 6.12514 8.17662 18.815 -2.86446 -0.617519 -0.818148 +567 2 5.41227 6.95692 0.781338 0.907384 -1.18964 -10.3034 +568 1 17.7111 15.8907 14.9544 -3.82577 1.28333 3.96962 +569 2 16.7386 15.9987 14.9233 18.3395 -0.0507343 -6.61585 +570 2 18.0408 15.7242 14.0577 -12.1828 1.42979 -0.226855 +571 1 13.1366 0.926204 16.6604 -4.9212 9.87611 -1.92759 +572 2 14.096 0.89187 16.7156 4.29984 -5.34206 5.94224 +573 2 12.8563 0.0335376 16.4436 -2.56348 -3.63873 3.02874 +574 1 10.9184 14.5253 7.38829 1.38398 -2.03118 7.00079 +575 2 10.1136 14.2278 7.85844 13.304 -1.52714 -8.95405 +576 2 11.6006 13.8396 7.51991 -9.17062 7.88742 -1.04716 +577 1 17.6363 8.46247 2.12178 -2.04395 4.31685 9.18728 +578 2 16.787 8.41765 2.58806 4.70486 1.56362 -5.63911 +579 2 17.6123 7.75928 1.47082 0.631216 -3.65047 -4.17578 +580 1 12.4375 7.79355 2.00637 -2.34281 23.5579 2.73553 +581 2 11.9501 8.63365 1.95534 8.51098 -6.49732 1.55884 +582 2 12.0343 7.24559 1.33225 -2.11395 -7.52965 -2.88654 +583 1 12.0451 14.5968 10.4885 2.58602 -10.5702 -25.2135 +584 2 12.3016 14.3716 9.56719 -0.183055 2.34539 21.1217 +585 2 11.1058 14.7694 10.4266 -10.5567 0.791778 1.58055 +586 1 6.78603 6.87835 15.4866 -3.36028 4.68136 22.1121 +587 2 7.71026 7.02894 15.2668 2.14313 -2.1467 -3.22881 +588 2 6.63472 7.41247 16.2893 -0.664868 -8.24615 -12.946 +589 1 7.99755 4.5041 13.3499 24.8278 34.1767 5.68201 +590 2 7.17338 4.66838 12.8997 -9.34484 -1.26894 -9.57598 +591 2 8.42297 5.40326 13.4231 -14.2483 -32.2403 1.51042 +592 1 13.3614 12.2059 14.3726 -2.68828 -3.01756 -2.25781 +593 2 13.124 11.2722 14.2967 -0.0467593 -0.437755 2.8377 +594 2 13.7081 12.4264 13.5024 2.10157 3.54991 -1.69903 +595 1 14.5654 9.5448 7.2719 7.4337 1.87458 1.84958 +596 2 15.4192 9.97446 7.42049 -0.421966 -1.69006 0.109976 +597 2 13.9603 9.96019 7.88547 -6.00597 1.06642 2.40823 +598 1 12.7021 16.8399 3.28406 2.1329 2.22559 -4.89416 +599 2 12.9627 17.2776 4.09814 -1.16793 0.633127 5.57798 +600 2 12.5029 17.5595 2.67417 -2.21511 -1.15635 -1.62469 +601 1 1.01088 7.06774 17.3689 20.0897 -7.47151 2.1243 +602 2 0.171968 6.83932 17.7636 -13.4375 4.7826 3.09836 +603 2 0.861358 7.69882 16.662 -3.49993 1.38105 -6.69635 +604 1 12.9265 4.90969 15.692 -1.72339 7.7777 5.20839 +605 2 13.7461 4.44088 15.8455 2.50132 -9.36464 -4.69309 +606 2 13.1831 5.83499 15.7716 0.254864 4.72294 -0.0726576 +607 1 2.3277 3.38915 5.11911 5.08689 -5.27649 -8.37414 +608 2 1.81648 3.03652 5.84872 -5.99705 -1.71944 1.12123 +609 2 2.79757 4.13118 5.49603 6.03185 12.6803 -1.33855 +610 1 8.22299 10.983 13.6596 -2.68868 6.78672 22.55 +611 2 8.37046 10.9349 14.6227 -7.71168 -0.54916 -12.6902 +612 2 9.06889 10.7219 13.2955 2.07822 -5.6604 -8.58071 +613 1 12.9566 1.54883 13.2404 -6.45532 19.0424 -4.61407 +614 2 13.4436 1.59622 12.409 4.66376 -6.5769 4.30334 +615 2 12.5511 2.44176 13.2892 3.97521 -19.3883 2.5587 +616 1 6.59697 13.6382 2.12308 -19.53 14.6785 -2.92569 +617 2 5.9569 13.9305 2.80289 7.92829 -3.31956 -9.9577 +618 2 7.23585 13.1086 2.59101 5.128 -6.56439 5.02766 +619 1 15.8657 6.47234 12.6041 4.99369 -6.06314 4.28807 +620 2 16.4551 6.98041 12.0348 -2.62867 1.80518 0.0955392 +621 2 16.3109 6.45259 13.4696 -4.62358 3.40022 -7.66147 +622 1 16.7868 0.706192 9.5524 8.10763 10.4692 12.0206 +623 2 16.4993 18.5236 9.95191 3.55616 -11.3811 -4.24312 +624 2 16.3059 0.843102 8.73445 -6.13335 -2.9453 -10.1224 +625 1 6.15553 11.6636 8.28166 8.04937 9.43191 -5.2183 +626 2 5.38812 11.3133 8.7152 -15.4132 0.789816 9.90132 +627 2 6.60546 10.8728 7.99206 7.62403 -6.5238 -2.76924 +628 1 2.80481 8.67956 0.357522 -16.6853 -5.97365 -15.2844 +629 2 2.27492 8.26466 18.2845 10.7138 4.85897 15.9492 +630 2 2.22127 9.36062 0.722932 4.52332 -2.29686 2.25001 +631 1 10.1103 10.3863 6.60128 -6.60242 -1.42487 -6.12592 +632 2 10.6136 9.70804 7.05871 2.40377 -4.05953 3.76861 +633 2 10.2954 10.2785 5.66001 4.13032 2.32994 2.59513 +634 1 6.85077 15.7563 6.70738 -11.7521 -4.07497 3.77538 +635 2 6.99262 16.2462 7.53077 3.71638 -1.24183 -4.26209 +636 2 6.92978 16.3894 5.98454 6.68147 0.141382 -0.214337 +637 1 6.48958 12.9529 5.78988 1.80967 -1.32299 -1.48619 +638 2 6.5811 13.8382 6.15183 4.24501 4.33378 1.70513 +639 2 6.11675 12.413 6.49523 0.159424 2.05888 1.44919 +640 1 16.7629 12.5191 9.71336 -1.62109 -11.3708 1.97787 +641 2 17.0324 11.8284 9.09183 -7.38478 2.50021 2.06117 +642 2 17.4395 13.1763 9.61316 3.98731 12.5093 -0.628579 +643 1 6.20997 2.89816 2.77935 -0.0802363 -5.63791 0.773513 +644 2 6.61167 3.74714 2.54082 -9.15989 -2.58724 -3.98308 +645 2 5.63039 2.60429 2.05445 8.60419 4.25286 3.07741 +646 1 10.7636 3.09526 3.23748 -2.12809 -1.19847 1.63085 +647 2 10.0581 3.70038 3.49376 4.9418 2.80865 -0.749542 +648 2 10.4122 2.60071 2.48751 -0.504171 1.44253 0.108713 +ITEM: TIMESTEP +80 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.8014 6.74321 17.9894 -25.71 0.163943 4.88408 +2 2 7.93592 6.85831 18.4426 18.3019 -2.2716 -9.29 +3 2 8.62145 6.12739 17.2721 4.06901 -0.284928 0.869098 +4 1 0.193099 8.36013 6.75275 5.74913 -14.5769 25.1987 +5 2 0.349094 8.05034 5.86501 -0.249861 0.708817 -17.2091 +6 2 0.558161 7.64099 7.32168 -7.5605 18.9357 -7.69302 +7 1 8.61156 0.29086 6.89037 18.8351 -6.84677 1.91716 +8 2 9.54524 0.192133 6.6105 -17.2936 6.40231 3.46958 +9 2 8.24205 0.986486 6.33979 -0.485036 0.67975 -2.4356 +10 1 6.46061 1.74084 11.7563 18.0716 -9.05138 -10.6926 +11 2 5.90902 2.36746 12.1907 -18.8993 15.6687 11.8916 +12 2 5.86943 1.07894 11.3852 -0.461453 -6.159 1.34784 +13 1 6.94761 5.53992 2.37529 -6.07193 26.0011 19.9509 +14 2 6.56484 5.89454 3.23997 6.76459 -12.0871 -41.8379 +15 2 6.81469 6.2225 1.67437 0.333839 -16.9501 17.8189 +16 1 16.2464 10.2212 16.095 -30.9636 -1.96085 19.7441 +17 2 16.8891 10.4896 15.4774 30.9665 9.88757 -18.0257 +18 2 15.7638 11.031 16.3423 6.62567 -11.9253 -3.68232 +19 1 10.7594 14.9468 2.28506 -10.192 -15.3258 -5.27915 +20 2 10.552 14.3194 2.98639 5.50444 -0.296801 2.35986 +21 2 11.1642 15.6696 2.7411 11.3222 17.7739 6.10774 +22 1 17.1862 8.22111 10.8759 16.4539 0.643281 -9.91552 +23 2 16.576 8.81969 11.3105 -3.64966 6.67804 4.28607 +24 2 17.949 8.77387 10.614 -8.44523 -5.92405 1.0378 +25 1 14.6358 16.0024 16.3895 25.5058 -11.0228 4.42293 +26 2 13.7352 16.2786 16.3126 -22.3429 5.97271 0.576342 +27 2 14.7081 15.5263 17.2386 -3.54281 4.69451 -12.0743 +28 1 12.1273 13.3164 0.564829 -0.361627 4.24339 0.0908299 +29 2 11.7754 13.443 18.3303 1.85705 -5.04776 -15.4247 +30 2 11.6653 13.9884 1.07404 2.42612 -1.45379 10.2607 +31 1 9.30563 5.48822 3.87958 6.5447 0.0363683 25.4904 +32 2 8.87806 5.40536 4.77034 1.54217 -0.907852 -25.4465 +33 2 8.62277 5.52424 3.19838 -5.81373 -1.17005 3.72822 +34 1 1.59219 3.96918 11.5778 -9.84269 42.1113 -23.7424 +35 2 1.65598 4.94531 11.7448 -5.32168 -23.4604 1.30407 +36 2 2.08682 3.52502 12.2368 16.8537 -14.859 24.6718 +37 1 2.0876 6.92307 8.18563 -3.73767 -8.57072 -0.0346284 +38 2 2.39381 7.30463 9.00964 5.23298 7.68032 1.6714 +39 2 2.09597 5.97338 8.35948 -3.7573 0.82597 0.238295 +40 1 5.28961 4.49122 7.85762 -5.23337 8.41869 1.15392 +41 2 5.42981 3.54006 7.92701 -4.09922 -6.37036 -7.26013 +42 2 4.64396 4.70759 7.15783 7.0556 -5.183 4.67383 +43 1 3.36027 2.89954 17.3915 -17.4395 12.4687 22.0366 +44 2 4.05476 3.43419 17.006 5.24509 0.828911 -8.29254 +45 2 2.77379 3.5226 17.8911 18.871 -11.3769 -11.5396 +46 1 7.49453 5.42535 6.18785 1.1565 -0.337813 22.5495 +47 2 7.9164 5.96716 6.90215 -9.87324 -14.4944 -23.4171 +48 2 6.89327 4.79051 6.63979 12.0833 17.318 -7.46699 +49 1 9.81909 7.02563 12.0706 7.31099 -1.858 8.99458 +50 2 10.1534 6.27284 11.5881 4.21769 -4.6772 -1.38273 +51 2 9.09614 7.33889 11.5389 -11.6555 6.63577 -10.586 +52 1 13.987 3.72336 8.09074 -16.8343 16.962 -37.2017 +53 2 13.5442 4.52839 7.7245 12.4076 -19.615 9.33911 +54 2 14.2201 3.91921 8.97962 7.00657 7.67382 26.2916 +55 1 4.5104 17.1281 3.91533 10.7578 31.6451 -21.4766 +56 2 5.3439 17.6347 3.91183 -5.56531 -14.4645 11.3324 +57 2 4.01019 17.58 3.20396 0.717673 -14.6313 13.083 +58 1 16.3456 16.5752 10.4878 9.47486 -6.83722 -28.8723 +59 2 15.5139 16.524 10.9378 -17.3385 1.90191 12.1775 +60 2 16.1667 16.1386 9.62748 3.54118 4.50203 14.5107 +61 1 1.9669 4.78352 0.127126 -0.739304 -4.30462 13.1261 +62 2 2.4124 5.1813 0.904759 -4.07407 -0.50297 -16.3737 +63 2 1.70825 5.48663 18.1668 4.40273 7.87995 3.28325 +64 1 11.3312 13.2592 16.4181 -1.15069 -16.7597 -15.9919 +65 2 10.8158 12.4247 16.4648 10.4615 17.429 3.38388 +66 2 11.9137 13.1122 15.6483 -5.75273 4.84583 10.0297 +67 1 10.0951 10.9476 16.7865 12.4257 -21.5163 1.40398 +68 2 10.4762 10.0399 16.7888 -6.98476 25.4172 2.00859 +69 2 9.15392 10.8219 16.7533 -12.5538 0.302602 -1.38706 +70 1 11.8287 17.486 13.4829 -0.118354 -13.6364 7.15806 +71 2 12.4458 16.8683 13.0504 -5.40922 13.24 -3.88075 +72 2 12.1685 18.3769 13.3708 4.2975 6.3924 -3.60834 +73 1 6.40329 9.45666 12.3007 7.59953 -15.5921 -26.3915 +74 2 7.02951 9.14458 11.6116 -13.6176 6.52201 11.0115 +75 2 6.95635 9.88774 12.9378 9.38595 10.7935 13.1394 +76 1 16.3024 12.9052 2.74142 -15.9403 -16.7132 8.77179 +77 2 17.1501 13.3041 2.5727 9.16723 7.57391 -3.15506 +78 2 15.6647 13.6204 2.85813 1.6204 2.22565 -2.39426 +79 1 0.760847 12.751 5.87222 -24.7031 -12.948 -13.3423 +80 2 1.12648 12.6956 4.9713 -1.82207 2.12621 9.26767 +81 2 18.4428 12.5289 5.74368 26.1358 12.2861 6.31515 +82 1 5.29492 16.3822 18.4146 -5.77927 -1.1636 -2.25588 +83 2 5.45161 15.4933 18.0434 4.5004 13.3336 10.181 +84 2 5.72207 16.4863 0.6292 0.349856 -6.54957 -3.00829 +85 1 0.672446 7.71977 4.17015 11.9206 5.83738 -2.65809 +86 2 0.0599114 7.99601 3.47788 2.17241 0.0211014 0.560686 +87 2 1.51354 8.18303 3.96741 -13.409 -12.9126 0.0558484 +88 1 3.18041 9.04016 6.47644 -48.733 9.26031 0.132627 +89 2 3.67612 8.69495 7.19851 13.8171 -10.3779 15.348 +90 2 2.22175 8.86945 6.71565 32.4894 5.10639 -10.1715 +91 1 7.33809 10.425 16.1982 -13.7714 -1.76245 23.4597 +92 2 6.52669 10.798 15.8343 6.52641 -1.5478 0.375626 +93 2 7.11414 10.2397 17.1395 3.58358 2.1532 -21.3577 +94 1 11.0368 0.910412 5.00755 -5.03762 -2.37072 -20.9965 +95 2 11.0166 1.76948 4.5572 3.99116 -0.122414 9.27702 +96 2 10.8085 0.318039 4.26499 2.41704 1.78329 12.9529 +97 1 4.27055 2.90822 13.1584 -5.03414 2.69466 11.7405 +98 2 4.39065 3.48249 13.9384 2.16314 -12.4788 -5.29849 +99 2 4.11656 2.00207 13.4974 4.2297 10.0998 -5.7581 +100 1 8.47529 10.248 1.79037 -0.416679 -17.2671 7.19176 +101 2 8.23967 10.8662 2.49257 2.8179 1.08296 2.51337 +102 2 8.59639 9.37915 2.23271 0.0130336 16.1865 -5.8343 +103 1 10.3383 1.70852 15.4843 -18.7352 2.46602 -2.29408 +104 2 11.1863 1.36274 15.7269 17.9639 -3.17473 -1.31836 +105 2 10.261 1.74525 14.5183 4.02029 2.26456 4.98686 +106 1 2.61381 12.97 7.91629 0.377646 -9.00714 -10.2558 +107 2 3.20736 13.521 7.38885 -1.73045 4.27865 2.80704 +108 2 1.92972 12.6563 7.30106 5.76016 2.06086 0.889789 +109 1 3.8265 11.6489 4.94253 -18.049 0.292651 15.0893 +110 2 3.64515 11.1228 5.74952 0.240622 6.04317 -17.8646 +111 2 3.00147 11.7074 4.41136 14.7829 -0.870145 11.9003 +112 1 6.67003 14.5068 16.9871 0.195301 -8.52391 -8.20479 +113 2 7.30673 15.1853 17.2075 3.81359 1.00594 1.02421 +114 2 6.51415 14.5784 16.0351 -3.74805 4.58221 3.23833 +115 1 14.2005 14.4991 3.2542 12.2104 -4.1759 -13.149 +116 2 13.9664 15.4191 3.35064 -8.52353 7.22912 -0.280994 +117 2 13.8358 14.0368 4.00136 -6.61808 -5.66537 10.7242 +118 1 8.64986 18.0488 16.0994 -35.3958 -9.60596 -0.188096 +119 2 9.08138 17.255 16.4541 14.3634 13.9351 -5.51429 +120 2 9.16615 0.19969 15.9552 18.9441 -0.541676 3.30098 +121 1 4.69447 1.75392 4.88991 25.859 26.3088 -12.7751 +122 2 3.87089 2.24691 4.93296 -3.58784 0.203107 2.94233 +123 2 5.32887 2.35869 4.40805 -22.2668 -23.8988 10.2256 +124 1 15.0337 12.5563 16.5322 -9.42235 19.0778 45.1845 +125 2 14.5415 12.8308 17.3429 25.2588 -5.91919 -13.7907 +126 2 14.3516 12.6025 15.8912 -15.7131 -4.7436 -33.7881 +127 1 15.7107 18.4933 16.8499 14.0119 15.6823 26.0515 +128 2 16.2364 18.5256 17.6977 -11.7154 -4.95338 -28.5838 +129 2 15.2517 17.6535 16.8181 2.70767 -12.4638 1.72062 +130 1 1.36288 1.31672 16.6317 -8.11361 12.6727 12.78 +131 2 2.12452 1.88684 16.8387 -7.41596 -12.3761 -6.73343 +132 2 0.666274 1.64987 17.2352 10.0682 -8.10993 -10.4284 +133 1 18.2119 4.36953 15.9172 -1.70541 -5.24792 -22.7614 +134 2 17.9042 3.81192 15.1707 6.44647 9.66147 16.3107 +135 2 0.476259 4.62247 15.7042 -5.76089 -2.38794 2.9761 +136 1 12.1484 17.0613 16.1489 -25.1744 -26.2572 32.1897 +137 2 11.4087 16.4938 16.5203 28.1495 25.8696 -8.33389 +138 2 11.9925 17.0682 15.2174 -4.06343 5.18838 -23.7308 +139 1 16.1307 2.63053 18.236 -24.4255 7.46546 -12.7341 +140 2 15.654 3.45006 18.4862 10.3096 -12.6534 -4.96798 +141 2 15.8825 2.42572 17.3162 0.942238 5.76458 9.76029 +142 1 6.69125 13.7819 10.0957 6.51523 5.30674 14.72 +143 2 6.68166 13.4115 10.9958 -3.31201 0.605957 -8.104 +144 2 6.74207 13.0463 9.48799 -5.76864 -9.77159 -4.40801 +145 1 10.1909 18.4566 2.69612 24.6552 12.5235 -11.9688 +146 2 10.5208 0.299966 1.90483 -6.63917 -6.88653 20.5003 +147 2 9.33855 18.1401 2.45819 -23.0922 -9.86885 -6.30041 +148 1 3.05041 17.6833 6.1612 -20.7399 0.346779 9.3758 +149 2 2.11766 17.6882 5.81771 32.7543 -5.44367 1.96306 +150 2 3.663 17.6288 5.4193 -6.60477 0.357372 -5.21379 +151 1 12.6301 16.8021 7.91443 2.73044 3.22351 -7.20597 +152 2 11.8394 16.2829 7.68186 3.48899 3.70212 12.2186 +153 2 12.4619 17.4281 8.63963 -10.075 -5.48551 -5.536 +154 1 14.8863 15.2402 8.20999 -23.6436 14.8183 29.3151 +155 2 14.1404 15.8836 8.27066 14.7388 -14.8318 -6.56535 +156 2 15.2763 15.3549 7.35467 9.52302 6.19548 -12.651 +157 1 17.8321 18.2493 0.273835 -34.2521 -9.59248 -4.32979 +158 2 18.5224 17.6645 -0.0392514 10.753 2.02465 3.4369 +159 2 18.2087 0.412934 0.595185 14.0613 13.0178 4.00109 +160 1 0.763956 10.5262 1.39925 -10.0074 -57.9186 33.1602 +161 2 0.0205775 9.86382 1.5781 27.9288 29.6193 -5.5527 +162 2 0.446448 11.1766 0.811593 -14.5912 25.5328 -23.4764 +163 1 1.80037 12.2889 3.30512 5.17734 11.597 19.2466 +164 2 1.46139 11.5987 2.74824 -6.10095 -9.75588 -16.5262 +165 2 2.13675 13.0044 2.75129 -3.9772 -2.70365 -1.85909 +166 1 0.682885 17.2588 4.99366 18.5034 24.5267 -32.7679 +167 2 0.107172 18.0117 5.16246 -8.54671 -5.12892 6.2039 +168 2 0.50047 16.4742 5.48014 -13.5055 -14.6224 21.6265 +169 1 1.0645 0.823506 9.34737 11.8193 5.83131 5.68962 +170 2 1.36557 0.594309 10.2448 -8.52979 0.55273 -0.975829 +171 2 0.153783 0.559257 9.28231 -13.2671 -5.76719 2.40467 +172 1 16.771 2.35127 13.3608 4.58635 29.8799 -13.6101 +173 2 16.8279 2.7166 12.4388 1.57782 -15.3367 24.752 +174 2 16.4858 1.44141 13.3191 -2.28737 -11.3359 -2.05688 +175 1 2.68433 15.9539 12.0479 2.00481 -8.12072 21.99 +176 2 2.97356 15.5639 12.9056 -4.45908 8.74231 -22.8774 +177 2 3.1524 15.4962 11.3314 -4.16555 3.83231 7.28649 +178 1 16.3902 15.5703 6.15458 18.8333 21.1033 -24.533 +179 2 17.3221 15.5371 6.43733 -15.6071 -4.56317 -0.523174 +180 2 16.3697 16.3474 5.53712 -7.15193 -24.3314 15.8574 +181 1 5.78808 5.16844 11.811 1.07675 -5.38543 -7.05048 +182 2 5.68145 6.03537 12.2081 -3.48533 4.06917 4.5041 +183 2 5.0592 4.65006 12.1655 2.16361 -4.54815 -2.94322 +184 1 15.172 4.89144 0.795633 -0.620892 -0.594882 26.39 +185 2 14.9156 4.81116 1.75201 7.19669 -4.64536 -26.7766 +186 2 14.3985 5.20255 0.336699 -8.8444 5.20324 -3.46854 +187 1 16.3986 16.4119 1.90339 15.122 14.6556 -26.5352 +188 2 16.0454 16.7612 2.71133 -6.27107 5.29423 17.303 +189 2 16.8063 17.1873 1.44657 -8.45441 -18.3773 8.08233 +190 1 0.184762 4.82044 3.92309 -20.0167 36.2337 -7.4234 +191 2 0.305381 5.80234 3.92557 1.42835 -23.0136 0.864842 +192 2 1.01251 4.4465 4.18098 17.0496 -9.16948 9.65169 +193 1 2.95853 15.072 15.1235 -0.929158 -18.0667 1.08146 +194 2 2.81752 14.526 15.9315 -1.93517 21.6459 -9.19578 +195 2 2.47159 15.9015 15.2035 -0.281788 -0.150795 8.17547 +196 1 1.08884 14.6409 9.4443 27.3966 -12.5379 -34.1186 +197 2 1.70575 13.947 9.05916 -23.9186 28.888 17.798 +198 2 0.66831 14.2301 10.1769 -7.64803 -12.9163 21.0233 +199 1 13.5173 16.5215 11.5364 0.489599 15.4909 -5.38356 +200 2 13.0836 17.2895 11.1076 8.88627 -7.75363 7.54599 +201 2 13.0704 15.7764 11.1287 -2.36322 -6.26123 2.87696 +202 1 4.73898 1.52078 0.69167 -9.68217 -10.6702 17.6377 +203 2 4.07875 2.00526 0.184075 4.46446 1.98443 -3.98397 +204 2 4.22033 0.928191 1.27988 9.48282 8.28471 -14.387 +205 1 1.52478 18.5784 11.9214 -16.2358 21.4234 -4.1613 +206 2 1.51367 0.493465 12.7143 -0.730917 -3.29007 -5.80239 +207 2 2.22048 17.951 12.0321 13.8924 -17.5303 6.45556 +208 1 11.4148 10.1041 4.08036 9.63761 14.6797 -7.17105 +209 2 11.6092 10.6619 3.28786 -9.14527 -18.7957 16.2306 +210 2 12.2661 9.96891 4.5224 -0.931524 1.73008 -8.63915 +211 1 8.18373 12.2132 3.70486 4.04638 8.18109 41.2935 +212 2 9.0456 12.58 3.98139 -6.62274 -6.35725 -9.04284 +213 2 7.64552 12.2934 4.54 8.66084 -3.68417 -28.5646 +214 1 14.5934 4.00277 3.33714 14.4882 6.32576 -0.110592 +215 2 15.3087 4.27672 3.93937 -11.245 -6.6719 -0.591331 +216 2 13.7777 4.36055 3.68688 -6.37652 3.17854 3.04506 +217 1 5.71814 1.6621 7.57513 -5.5313 -4.02265 40.0153 +218 2 5.00295 1.12677 7.97081 8.59667 7.25176 -1.51046 +219 2 5.48447 1.71188 6.6706 -7.03261 -0.519715 -37.0679 +220 1 17.8819 0.996597 4.84385 3.28334 1.22129 -8.70029 +221 2 18.3735 1.40853 4.10428 -5.78677 -2.02928 14.9184 +222 2 17.7642 1.64161 5.55539 2.20556 -0.0657175 -7.03701 +223 1 6.81886 9.28778 4.52861 6.25722 -6.76526 -10.2791 +224 2 6.61832 9.39383 5.45723 -0.00817066 1.76549 8.49843 +225 2 7.7574 9.04758 4.4954 -4.05712 -0.0763234 -2.03313 +226 1 2.4854 14.759 2.04442 -7.64745 -7.92423 -28.9185 +227 2 3.31932 14.7218 2.51092 7.63377 -1.04104 5.23896 +228 2 2.65881 14.5612 1.09422 1.17207 5.04057 23.1132 +229 1 17.2643 12.9213 13.1026 -19.9619 15.9168 2.25648 +230 2 16.3761 13.2301 13.4207 25.7036 -1.66639 -12.6722 +231 2 17.7779 13.7212 12.8621 -11.3949 -9.92691 5.05246 +232 1 14.8558 10.5579 1.44832 -24.1837 -11.6243 -0.0449549 +233 2 15.2498 11.3496 1.79784 9.85962 12.147 5.79114 +234 2 13.9164 10.5877 1.7065 14.7293 1.68269 -5.02708 +235 1 5.67033 6.62258 4.57309 8.95784 -16.3381 4.76769 +236 2 5.78141 7.53495 4.33529 5.34224 19.3995 0.612293 +237 2 6.44538 6.37316 5.11369 -12.1071 3.69782 0.132968 +238 1 8.08484 8.3464 10.3723 -2.79238 1.81559 10.704 +239 2 8.60215 8.86766 9.74634 -1.18548 0.238269 1.84293 +240 2 7.34937 7.94467 9.9053 0.580319 -4.15939 -10.1337 +241 1 13.4382 18.465 5.66883 -2.12963 -16.204 3.95429 +242 2 12.6402 0.317353 5.43723 -0.0049589 1.74147 2.86213 +243 2 13.1409 17.7635 6.28441 4.99057 13.7489 -2.35078 +244 1 -0.0389125 2.60201 0.358484 20.6019 -11.619 5.06808 +245 2 17.6744 2.57403 18.7483 8.04315 12.368 -1.45646 +246 2 0.347515 3.47455 0.194182 -8.07269 -1.54831 -1.2857 +247 1 12.9609 10.9078 9.72363 -44.1168 29.5082 -8.54535 +248 2 11.9486 10.9818 9.7709 44.2995 -10.8859 -2.13595 +249 2 13.1901 10.0051 9.91101 -8.5598 -18.2315 3.87517 +250 1 0.590645 12.1909 11.1498 11.7969 16.2942 20.6903 +251 2 18.3214 12.2032 11.4307 -13.062 -2.39731 -5.9775 +252 2 1.05781 12.4788 11.9545 1.3761 -3.96073 -11.1532 +253 1 5.19979 7.35251 13.3459 4.96104 -3.5954 0.621761 +254 2 5.77554 8.05147 13.0099 -6.36891 3.58923 -1.12306 +255 2 5.62026 7.07364 14.1664 0.643961 -0.709679 0.08133 +256 1 1.17273 6.78721 11.9743 -37.7935 -22.2758 -19.6174 +257 2 0.361865 7.16229 11.5551 20.1673 -8.51661 10.9701 +258 2 1.7013 7.51605 12.2195 19.7686 31.2325 8.39364 +259 1 15.5313 9.74152 12.3525 -7.42661 26.8763 14.1834 +260 2 15.1354 10.6339 12.1691 17.2848 -32.3992 2.44097 +261 2 15.9001 9.83422 13.2442 -4.7827 -6.0868 -10.0384 +262 1 16.5842 12.6457 5.58229 -7.58554 26.2756 -26.1768 +263 2 16.3849 13.5701 5.8413 5.71516 -14.5282 0.0223018 +264 2 16.4193 12.6729 4.60395 6.10391 -10.0799 23.5706 +265 1 6.38601 9.81704 0.0456579 -23.7849 0.890546 -8.41533 +266 2 5.51671 10.1854 0.278669 9.54818 -0.234306 -0.813632 +267 2 7.00687 10.1562 0.67255 15.5644 7.03716 17.2844 +268 1 12.2684 6.05846 4.00919 -28.2934 -33.3926 21.5663 +269 2 12.263 6.7861 3.41661 0.234348 22.4834 -18.769 +270 2 11.3224 5.76736 4.06199 25.4812 4.82389 -2.50319 +271 1 0.373791 12.8792 0.072054 -11.107 3.80906 -1.77299 +272 2 18.9015 13.5268 0.779758 -5.73011 -3.33995 1.31101 +273 2 18.3694 13.1354 18.0395 6.43374 -1.82904 2.53089 +274 1 3.55692 18.7013 8.65073 14.893 -16.0199 -12.5754 +275 2 3.38339 18.1698 7.85699 7.36237 7.58391 1.53928 +276 2 2.68044 0.23403 8.96368 -11.3363 8.83032 5.06178 +277 1 7.32525 17.3963 4.4514 17.4309 29.7426 -3.23332 +278 2 7.82401 18.2131 4.74166 -23.0386 -26.7058 -8.39786 +279 2 7.43189 17.3694 3.48275 -1.39589 -2.42936 11.5599 +280 1 9.26525 17.1572 12.169 8.13396 -3.40366 20.592 +281 2 9.29678 16.2438 11.8433 -0.925088 7.81756 -3.33389 +282 2 9.96734 17.2329 12.8546 -10.0311 -2.0771 -17.5408 +283 1 13.2786 13.1508 8.01112 -12.5044 -28.1533 13.0431 +284 2 13.4287 12.5256 8.7581 -3.83031 10.1919 -19.0767 +285 2 13.9208 13.8439 8.10408 14.3758 9.62768 2.82629 +286 1 14.7717 2.95063 15.4663 23.0059 6.37496 -12.5686 +287 2 14.1149 2.31 15.1961 -5.56432 -5.96018 -2.11564 +288 2 15.3514 3.08539 14.6861 -8.35989 -8.63193 12.4086 +289 1 9.95789 15.6422 16.9764 -4.46993 0.793564 -8.8018 +290 2 10.2307 14.8148 16.5569 1.31144 -2.42354 4.42353 +291 2 9.44172 15.4 17.7473 1.0906 -3.95706 9.45227 +292 1 11.2531 8.54113 16.6333 5.17657 0.0418295 -8.84929 +293 2 10.6325 8.00272 16.1399 -5.6117 -5.11655 -0.169214 +294 2 11.5912 7.9918 17.3372 0.751532 -6.83429 5.96975 +295 1 4.09617 18.2775 16.8038 -1.75476 28.7193 2.74196 +296 2 4.5979 17.7227 17.3968 3.26159 -10.0112 3.6984 +297 2 4.13851 0.526798 17.2077 -3.53746 -18.1625 -9.44923 +298 1 2.30039 4.26982 8.91686 21.6694 -5.11589 23.5763 +299 2 3.26852 4.19272 8.75344 -21.2665 0.643644 3.82423 +300 2 2.17319 4.0769 9.88449 2.25335 4.47185 -28.5355 +301 1 9.91449 10.4045 9.82138 -1.36818 12.3774 -23.5261 +302 2 9.54718 11.2486 9.48103 5.13969 -13.6804 7.80682 +303 2 9.93694 10.4191 10.7736 0.214264 3.33848 13.7587 +304 1 9.74784 0.927945 10.8307 17.8645 8.52415 0.395599 +305 2 9.30432 0.217271 11.2949 -5.1784 -7.81016 -3.03012 +306 2 9.13824 1.32484 10.1982 -3.45577 -3.9008 2.04599 +307 1 9.17195 15.1281 10.2005 -15.5022 -1.44929 -2.09464 +308 2 8.96814 15.9769 9.77108 -2.08214 -7.76738 2.59404 +309 2 8.35001 14.5895 10.1068 18.2617 13.451 2.66111 +310 1 0.828362 9.74081 10.2167 22.8302 -4.53826 -35.6406 +311 2 0.863435 10.6794 10.4661 0.846835 -12.3508 -3.07098 +312 2 1.42185 9.63122 9.40918 -26.8549 6.26386 38.0517 +313 1 17.1622 4.86379 8.08044 2.41554 -11.1764 16.204 +314 2 16.3163 5.29453 8.26848 4.74994 -0.845127 5.21041 +315 2 17.4172 4.31929 8.8662 -8.72341 14.5987 -22.1578 +316 1 14.8039 14.6747 0.0449816 -17.091 -7.62196 19.0468 +317 2 15.3137 15.169 0.695817 3.50252 1.08273 0.82912 +318 2 14.0068 14.3765 0.533797 12.6241 2.78049 -10.2188 +319 1 3.85026 11.0642 9.5563 -2.44831 7.24975 -16.8488 +320 2 3.90516 11.4403 10.4374 -3.64435 1.57263 7.30128 +321 2 3.45144 11.7342 8.96857 -1.60708 -4.46554 10.9787 +322 1 11.3552 10.7376 1.50363 23.7004 17.8717 -7.90317 +323 2 11.5499 11.5913 1.05012 -4.60225 -16.5984 9.56505 +324 2 10.4091 10.6312 1.49605 -14.4596 -0.264671 -3.06241 +325 1 13.1456 7.20328 12.6021 -24.9249 -2.39855 5.22786 +326 2 14.066 6.96941 12.5913 17.2615 -6.20786 -1.13088 +327 2 12.6433 6.37391 12.7221 9.22616 8.00521 -2.5813 +328 1 9.63635 1.93928 0.908954 12.9918 3.25798 9.3487 +329 2 8.80616 1.72326 0.497356 -10.689 -0.461065 -8.23177 +330 2 10.2384 2.2422 0.224542 -0.105661 1.67982 -4.44056 +331 1 10.6547 13.4406 4.52244 4.65594 3.65244 26.3326 +332 2 11.5391 13.0824 4.73514 -13.2197 2.26822 -8.08889 +333 2 10.4444 13.96 5.32492 0.722291 -5.69425 -12.9779 +334 1 14.5068 1.61853 10.9473 1.56188 14.5139 4.90111 +335 2 15.3059 1.27791 10.528 -0.453964 2.70191 1.23402 +336 2 14.6742 2.57144 11.1203 -1.66622 -13.4066 -10.2612 +337 1 14.4999 12.0198 11.6401 -20.4 4.4823 -10.6844 +338 2 15.1901 12.5044 11.1683 0.00955556 -6.20474 -4.10181 +339 2 13.88 11.6279 10.9736 17.9431 15.8984 14.8698 +340 1 8.17874 5.12415 9.82106 -30.5984 10.5693 18.9492 +341 2 7.28241 5.07355 10.2519 27.6442 5.22023 -11.9731 +342 2 8.30253 4.26697 9.4335 2.62166 -17.6444 -4.58757 +343 1 1.47714 16.9429 18.4887 13.3148 33.7663 -28.6254 +344 2 1.86682 17.2437 17.6257 -9.89818 -8.00998 25.1444 +345 2 1.74527 16.0479 18.574 6.31239 -26.8006 -0.778427 +346 1 1.45374 17.3594 15.3268 42.8952 -1.15706 -0.811193 +347 2 1.42588 18.2136 15.749 -3.30828 11.7666 5.73369 +348 2 0.584657 17.0429 15.2318 -41.4551 -8.54136 -0.705167 +349 1 3.54007 5.76039 6.04888 -8.98595 6.80975 7.90297 +350 2 3.01039 6.43039 6.5207 7.85999 -10.8756 -2.65394 +351 2 4.1622 6.27284 5.52252 1.18276 -3.83664 -2.43702 +352 1 12.5413 9.50789 14.2278 14.1386 -34.2774 -1.94842 +353 2 12.9806 8.74877 13.7665 -10.1246 23.4373 5.48687 +354 2 12.3781 9.12309 15.104 -2.49329 10.5308 -3.54938 +355 1 4.07791 15.2392 7.05947 28.2061 -4.52306 7.60827 +356 2 3.62905 16.0551 6.82 -1.6925 3.55103 -3.37365 +357 2 5.05246 15.4367 7.04645 -25.4492 -3.49557 -3.60676 +358 1 0.767125 8.74429 15.1186 -1.35051 -1.02403 -4.71838 +359 2 0.502685 9.67668 15.1423 2.70563 -3.13172 -3.80763 +360 2 1.44028 8.65803 14.4206 -5.36892 5.64782 6.7911 +361 1 12.8556 8.29114 10.1154 40.5883 -11.1151 11.7349 +362 2 13.7543 7.93714 9.90509 -23.2563 4.30646 -4.77873 +363 2 12.8036 8.10553 11.059 -7.7965 -1.57596 0.639248 +364 1 15.3061 7.91627 3.47282 -42.6646 -27.0181 14.5138 +365 2 14.4087 7.67951 3.19876 7.83283 16.2655 -25.9683 +366 2 15.288 7.37548 4.27198 30.0578 14.5578 6.00353 +367 1 17.2193 6.75387 0.0348868 -24.2654 8.60155 -9.76068 +368 2 16.7331 5.97981 0.339573 3.08011 -1.47023 2.02216 +369 2 16.4984 7.35116 18.3587 20.6605 -10.5931 7.39935 +370 1 8.96527 6.96977 7.82312 -33.6536 -16.7811 13.5927 +371 2 9.86459 7.23854 7.79988 29.8916 7.79708 0.58286 +372 2 8.85329 6.36072 8.58482 2.84704 12.8992 -8.98126 +373 1 12.4369 0.615517 1.24835 5.12967 -8.6669 -10.2958 +374 2 13.1996 1.14046 1.50868 5.63 -3.81589 5.32704 +375 2 12.6841 0.248493 0.387703 -6.12727 4.87774 5.89397 +376 1 5.63437 15.0947 14.482 15.2573 18.1506 -1.5187 +377 2 4.74012 15.1756 14.8216 -5.87791 -1.19647 -0.853033 +378 2 5.96659 16.0211 14.4028 -4.19512 -21.3346 -4.32131 +379 1 3.78146 6.44452 1.71439 -10.0957 17.3086 -10.1533 +380 2 3.36154 7.20469 1.26344 3.84289 -8.07011 2.3383 +381 2 3.80108 6.73559 2.62781 1.97525 -3.80667 6.02801 +382 1 3.89131 11.3886 12.3597 10.4858 -4.45626 -8.95185 +383 2 4.75702 11.7925 12.5217 -6.56671 -1.88331 -0.935479 +384 2 3.25208 11.9718 12.7596 -7.39976 8.19237 6.18945 +385 1 5.30831 3.87649 15.7567 -11.2019 61.1278 12.0088 +386 2 6.01892 3.27998 15.6709 29.6235 -28.0721 -9.85567 +387 2 5.7476 4.76544 15.8793 -15.8563 -28.9516 -7.19779 +388 1 14.1175 10.173 4.66017 9.40425 -19.9217 -33.2768 +389 2 14.1461 9.82294 5.54158 6.86029 -3.38102 17.8715 +390 2 14.6328 9.51646 4.11155 -16.0552 24.3993 16.1239 +391 1 7.5636 17.329 9.02789 1.81886 -5.76611 4.78707 +392 2 6.9813 17.6417 9.74433 4.383 2.36677 -11.0761 +393 2 7.91242 18.0661 8.5041 -5.60089 1.56926 3.7162 +394 1 4.54646 14.4437 3.82391 2.35855 8.70422 24.1238 +395 2 4.58695 15.3758 4.17596 -1.73775 -31.732 -9.36156 +396 2 4.50325 13.8127 4.58585 2.14298 18.0212 -18.4803 +397 1 14.2437 7.3639 15.8726 24.9361 2.31774 6.81444 +398 2 15.0991 7.30759 15.3921 -17.5628 0.546592 9.39404 +399 2 14.5002 7.74932 16.7373 -8.89015 -4.19374 -15.8798 +400 1 3.04207 18.4209 1.96748 -18.4085 17.9201 24.7102 +401 2 2.5353 17.8449 1.40649 -4.22111 -10.717 -13.4847 +402 2 2.35407 0.262093 2.48798 16.8127 -9.3976 -15.4809 +403 1 7.96924 1.62215 4.56344 31.9424 -9.467 0.421552 +404 2 7.35201 1.92948 3.90341 -1.64239 4.88827 -11.6355 +405 2 8.85795 1.52282 4.13815 -26.2226 6.52533 8.08337 +406 1 2.457 14.1626 17.6995 -18.6259 -8.83368 10.0969 +407 2 1.68725 13.6009 17.9701 23.9808 13.2635 -8.93306 +408 2 3.24279 13.6711 17.9492 9.2771 -5.34798 1.51385 +409 1 0.927142 1.91914 13.8849 28.4694 2.81528 -14.4963 +410 2 1.17928 1.66855 14.7668 -1.31862 -2.11333 16.1229 +411 2 -0.00784116 2.01924 13.8762 -26.8609 -0.0423979 -2.90492 +412 1 4.3639 0.116891 13.871 19.5154 5.98388 -10.2249 +413 2 5.3312 18.592 13.8382 -18.25 -1.84578 0.0905254 +414 2 4.09014 18.5553 14.7613 -1.68072 -4.35498 12.29 +415 1 7.32185 0.935992 18.4254 -25.1976 4.88188 40.3736 +416 2 7.29261 0.583526 17.5599 3.22929 -13.7772 -30.1977 +417 2 6.39141 0.906009 18.7671 22.6248 8.40202 -10.9225 +418 1 15.9043 18.3822 13.9598 -30.4853 6.92778 -31.02 +419 2 14.9691 18.5865 13.6701 32.1757 -7.76669 18.1984 +420 2 15.9697 -0.290473 14.9111 -4.96086 4.78357 11.6174 +421 1 10.2566 4.62301 16.2429 -20.4053 -21.3362 -19.7333 +422 2 11.1923 4.47268 16.3843 6.75918 3.74651 0.0845893 +423 2 9.94726 3.80759 15.7722 8.97755 19.5704 18.0095 +424 1 15.9188 17.665 4.49409 -30.8876 16.8748 5.69015 +425 2 16.5463 18.3904 4.38809 -0.624131 1.21894 5.03495 +426 2 15.0755 18.0798 4.84388 28.6139 -15.2662 -13.1828 +427 1 6.9464 17.5119 13.903 30.1459 16.134 14.6047 +428 2 7.45538 17.7973 14.7126 -14.438 -11.5296 -22.8133 +429 2 7.62564 17.4897 13.1926 -14.0494 -3.94126 11.1274 +430 1 13.2241 6.43487 6.53037 -11.3028 -4.49966 -3.41689 +431 2 14.1722 6.56035 6.47079 5.41657 3.67276 -3.81812 +432 2 12.8747 6.35097 5.62176 7.42053 0.356932 11.8509 +433 1 7.85865 2.26615 9.45505 -4.28533 -3.16859 -37.0089 +434 2 7.29966 2.29372 10.2234 -12.0252 -4.85104 14.2867 +435 2 7.31757 1.89726 8.71059 11.6806 10.5906 18.7024 +436 1 15.1499 14.8389 13.7285 -7.78284 7.72319 0.275575 +437 2 14.8617 14.9509 14.6481 -0.524909 3.36892 -5.65775 +438 2 14.6832 15.507 13.1912 6.48748 -10.1003 7.43034 +439 1 9.39784 8.36731 3.82962 2.5344 -9.0015 0.237957 +440 2 10.2136 8.88179 3.87227 -2.41531 -0.25237 0.330419 +441 2 9.66909 7.4454 3.98022 -9.00345 8.8328 -4.59515 +442 1 17.7291 13.5977 16.4646 5.88425 13.7422 -6.32319 +443 2 16.779 13.4368 16.4502 -3.47507 3.66531 -1.64514 +444 2 17.9175 14.4327 15.9665 -10.227 -20.4783 11.0606 +445 1 4.89529 10.4518 2.85531 35.8078 -15.8912 -9.72696 +446 2 5.76001 10.066 3.12945 -20.0856 5.21459 -7.60385 +447 2 4.65599 10.9551 3.62329 -7.19184 9.4675 7.77805 +448 1 3.68184 8.40606 9.96257 -7.06038 -13.6752 25.4145 +449 2 3.73025 9.3314 9.75201 2.05841 13.8137 -4.67922 +450 2 3.5201 8.39907 10.9276 1.35511 -1.83367 -14.7667 +451 1 15.9506 6.91676 5.90036 8.23349 -12.8437 -5.59708 +452 2 16.7283 7.39089 6.23923 -5.44721 -6.23743 -4.31526 +453 2 16.2459 6.04307 5.54881 -4.37327 20.9496 12.2757 +454 1 15.2047 7.21919 9.02648 -8.23364 16.7266 -25.0777 +455 2 16.0013 7.62239 9.37026 6.97324 -0.496136 10.989 +456 2 14.9764 7.76869 8.23928 2.79192 -13.8116 16.1423 +457 1 6.18989 12.8346 12.7303 -2.33267 17.6694 7.57139 +458 2 6.82101 12.228 13.1265 8.54383 1.14333 3.13472 +459 2 6.09938 13.6243 13.3122 2.17121 -15.6415 -7.8487 +460 1 12.1177 4.51675 13.1173 40.066 24.623 8.84127 +461 2 12.3608 4.67527 14.0558 -10.9347 -6.25445 -11.8552 +462 2 11.2865 4.0907 13.0625 -30.7168 -15.659 3.72413 +463 1 11.4382 8.09379 7.90765 11.4031 -1.65515 0.349674 +464 2 12.1555 7.64923 7.40412 -12.1024 3.57709 12.4555 +465 2 11.7306 8.14579 8.84607 -3.22191 -0.660368 -24.1915 +466 1 17.0422 10.838 7.59458 18.8696 -14.9771 -17.3127 +467 2 17.8015 10.2845 7.30277 -16.9558 5.34042 10.7777 +468 2 16.8989 11.446 6.8574 -4.66599 0.747798 1.74373 +469 1 5.2881 18.0926 10.8094 -12.0199 -6.67836 -5.57022 +470 2 4.87565 17.5902 11.533 4.52174 5.42574 -9.9319 +471 2 4.66447 18.0398 10.0548 7.40461 3.40643 11.786 +472 1 7.61349 17.4864 1.6652 -5.64906 3.24499 15.5952 +473 2 7.84327 16.7088 1.17852 12.3306 -20.6776 -4.28559 +474 2 7.74119 18.1865 1.04014 -3.89506 18.5858 -12.7246 +475 1 1.91944 12.8991 13.6003 2.94725 10.7513 13.4495 +476 2 1.49936 12.2949 14.2301 -1.35275 4.24281 -4.32331 +477 2 2.12078 13.7179 14.107 -1.08361 -15.4355 -11.6139 +478 1 9.36899 6.74386 14.7638 -2.26814 18.4847 -3.39127 +479 2 9.81478 6.02606 15.213 8.95117 -11.473 0.808352 +480 2 9.85086 6.98618 13.9577 -2.76657 -9.1339 3.81591 +481 1 15.2853 4.27459 10.7783 -6.29839 -2.79317 -1.65183 +482 2 16.2088 4.11106 10.5808 3.62417 -3.44414 3.50356 +483 2 15.3067 4.91761 11.4912 -1.69264 4.92972 1.1484 +484 1 11.3393 6.23844 0.0959214 -19.2017 -19.0623 -2.27733 +485 2 11.4465 5.27934 18.8311 9.36926 7.99257 -4.22996 +486 2 10.3892 6.29463 18.5179 14.2332 9.643 5.73673 +487 1 18.5128 11.4549 14.9487 -3.47415 -8.47336 -12.1105 +488 2 18.0135 11.8846 14.234 9.23154 -3.06455 1.62932 +489 2 18.3213 12.0172 15.6945 1.79799 8.69016 10.3557 +490 1 7.01602 9.27569 7.3226 -14.4634 -16.8581 15.1781 +491 2 6.67273 8.48369 7.80259 5.98597 16.4947 -15.5019 +492 2 7.96023 9.16216 7.29002 13.6661 -3.40194 -2.89589 +493 1 18.3593 15.3216 12.2421 14.2565 8.37053 -9.09139 +494 2 0.609114 15.6531 12.0121 -9.26774 -5.34503 6.02371 +495 2 17.7657 15.7501 11.6106 -0.96984 1.15192 3.02291 +496 1 16.5123 4.36636 5.2899 -20.1169 0.0802899 32.1896 +497 2 16.6197 4.39367 6.27015 0.689823 -6.50354 -17.1519 +498 2 17.3637 4.55338 4.93619 30.7718 -0.208347 -14.1282 +499 1 17.7452 3.18489 10.789 3.81546 21.3325 5.47337 +500 2 18.6747 3.34524 11.0396 -11.7638 -6.52287 -4.76545 +501 2 17.6832 2.38146 10.2881 5.2294 -17.628 -7.02183 +502 1 12.3161 18.6216 10.0891 7.2643 12.1904 3.38538 +503 2 11.4836 0.405415 10.3905 15.4316 -4.87983 -6.88019 +504 2 13.0526 0.636416 10.1289 -21.6037 -8.70048 2.57237 +505 1 10.3866 9.75789 12.4872 13.2725 15.9888 14.5072 +506 2 11.1625 9.86545 13.086 -15.7493 -4.39745 -10.7974 +507 2 10.2528 8.81785 12.4 2.63286 -10.7197 -2.15993 +508 1 0.710964 2.68685 7.1375 -0.1398 22.218 7.12103 +509 2 0.988905 3.47272 7.66294 -4.49485 -18.6961 -10.7978 +510 2 0.93208 1.94131 7.68754 4.63119 -8.38422 8.20051 +511 1 0.281684 15.3172 6.85959 12.828 -38.7344 -20.2135 +512 2 0.500898 15.7193 7.67574 7.5107 6.97721 30.9172 +513 2 0.662709 14.3998 6.92418 -16.2289 29.7866 -9.89698 +514 1 17.0547 6.94606 15.0133 0.165691 -3.90506 -0.393601 +515 2 17.812 7.5465 14.9118 -2.55694 -6.08978 1.76467 +516 2 17.3809 6.10212 15.3719 1.63232 8.8395 -1.4121 +517 1 9.12112 12.493 8.02809 -41.9273 18.4298 17.1595 +518 2 9.51251 11.917 7.38329 0.012751 -17.4797 -14.5944 +519 2 8.13115 12.5622 7.88239 38.3085 -7.50107 -2.24579 +520 1 1.15265 1.71178 2.84381 -8.4531 -11.9611 -9.59212 +521 2 1.05399 2.26522 2.05124 -0.803687 -1.8039 9.5303 +522 2 1.83355 2.04817 3.41993 6.13064 16.5152 3.77918 +523 1 4.1533 15.0772 10.0179 -3.20174 -0.437736 -9.29092 +524 2 3.98656 15.1016 9.06421 1.0299 1.2944 4.52592 +525 2 5.05261 14.7702 10.1253 7.00528 -3.42074 -2.93025 +526 1 7.40026 2.22746 14.7687 6.49168 5.19513 -3.0061 +527 2 7.05161 1.63346 14.1063 -3.12724 -4.90201 -3.09738 +528 2 7.91685 2.87588 14.258 -12.5256 -3.95349 11.2802 +529 1 18.373 14.546 2.1576 32.8202 -8.56769 3.71586 +530 2 0.641523 14.7991 2.40659 -13.3331 -4.12423 -2.43111 +531 2 17.8688 15.3457 2.17573 -14.9783 16.0191 -2.18472 +532 1 10.0269 2.72027 12.9069 6.62939 -13.0178 -15.3878 +533 2 10.0552 2.15154 12.1041 -3.85604 9.52515 15.5624 +534 2 9.22213 3.24102 12.837 -1.7712 4.41938 -1.42751 +535 1 2.97754 8.87028 12.9985 -9.05038 -0.677068 -3.47801 +536 2 3.45417 9.69118 12.8049 -4.31376 -0.734034 1.18179 +537 2 3.62806 8.2766 13.3769 7.01874 -2.97808 -1.19575 +538 1 3.19567 8.6035 3.77658 -19.8399 -15.185 62.8422 +539 2 3.69787 9.2024 3.27039 20.7823 26.7884 -21.1607 +540 2 3.25417 8.93577 4.73429 1.71088 -18.6185 -45.3432 +541 1 5.68333 7.2353 8.59567 4.24349 7.94903 8.11652 +542 2 5.64033 6.27333 8.54735 -2.49289 0.630165 -0.0839225 +543 2 5.00997 7.53803 9.22801 3.10928 -6.89318 -6.51723 +544 1 14.901 1.57394 1.8387 15.5968 1.99798 -17.643 +545 2 15.036 2.2757 2.46438 -7.07983 8.8607 13.8203 +546 2 15.4483 1.85956 1.08282 -11.9705 -11.4344 6.74504 +547 1 8.60581 15.0641 0.724175 -1.0343 -0.581701 -1.65436 +548 2 9.36267 14.9264 1.3224 -11.0408 7.07619 -5.07103 +549 2 7.85377 14.5885 1.11097 4.42293 -0.805501 -0.698164 +550 1 15.4669 1.42093 7.20398 -6.02567 -16.758 -12.9624 +551 2 14.8047 0.91537 6.67859 11.4397 13.2212 12.6179 +552 2 15.1632 2.33261 7.23494 -7.42764 0.585266 4.6538 +553 1 4.96609 12.9239 18.4605 4.9692 1.49742 18.5571 +554 2 5.35493 12.9668 0.719228 -7.36506 -0.705061 -15.6984 +555 2 5.64055 13.3191 17.899 -0.422768 -0.432726 -0.922633 +556 1 15.3869 8.64959 18.0541 15.2167 5.00615 -15.1922 +557 2 15.9585 9.21901 17.4831 -18.3202 -12.4364 12.18 +558 2 15.1184 9.19177 0.153179 1.36579 6.92031 5.44875 +559 1 12.0051 3.11685 18.332 2.92261 2.37371 -0.430118 +560 2 12.2267 2.91556 0.611981 0.907964 -7.8545 -12.3252 +561 2 12.4512 2.48545 17.7302 -5.34745 5.71129 14.8863 +562 1 13.1901 12.7142 5.17454 1.37013 -5.58194 -4.10925 +563 2 13.4698 11.8626 4.7966 3.05379 7.74077 7.48289 +564 2 13.3871 12.6804 6.11832 -0.290674 -0.040691 0.190289 +565 1 6.14326 7.19304 0.194857 -1.9202 -41.4233 1.79985 +566 2 6.22321 8.10871 19.0299 -3.97355 27.3971 1.06104 +567 2 5.34431 6.86352 0.645447 4.46952 5.26437 -3.48858 +568 1 17.7307 15.8888 14.9367 -21.823 -0.594011 -1.7362 +569 2 16.7484 15.9241 14.9389 21.2696 3.13718 0.352088 +570 2 17.9521 15.7271 14.013 1.78287 0.501162 -2.11552 +571 1 13.1218 0.925759 16.6825 5.50042 -3.78674 2.95198 +572 2 14.072 0.793445 16.8378 -4.97223 1.91263 -2.37602 +573 2 12.7827 0.0340456 16.5234 -2.01103 3.41826 1.69274 +574 1 10.8951 14.5133 7.41586 13.7556 -0.655539 -10.0126 +575 2 10.113 14.0867 7.762 -7.55253 -2.39401 4.078 +576 2 11.587 13.8348 7.46973 -1.14 7.89944 2.21203 +577 1 17.6887 8.43188 2.14728 0.189858 20.0466 16.1607 +578 2 16.8137 8.45099 2.54699 -1.17102 1.13639 1.13697 +579 2 17.5844 7.88298 1.39033 0.906265 -19.3865 -19.2668 +580 1 12.4753 7.78007 2.02858 4.8513 20.3782 0.840615 +581 2 12.1866 8.68618 1.79587 0.511972 -15.0552 5.00442 +582 2 12.026 7.17575 1.43189 -2.95773 1.13832 -8.42618 +583 1 12.0482 14.5597 10.5042 0.0757192 -7.5571 -35.1431 +584 2 12.4064 14.4181 9.58152 -17.4466 3.18024 31.1693 +585 2 11.0871 14.7065 10.4137 10.382 -0.64313 -2.04102 +586 1 6.77399 6.81718 15.4895 -2.25325 13.5751 22.5023 +587 2 7.66157 7.15195 15.2455 -13.2429 -8.30723 6.82645 +588 2 6.46823 7.3192 16.2828 11.602 -10.345 -19.2772 +589 1 7.96932 4.46689 13.3146 44.2968 21.2749 25.8476 +590 2 7.30275 4.56825 12.6635 -24.5307 9.83264 -18.6775 +591 2 8.36434 5.36687 13.4905 -14.8867 -29.3495 -5.61281 +592 1 13.3256 12.2141 14.3822 1.63527 0.767161 7.05401 +593 2 13.3071 11.2456 14.3976 -5.0343 3.13323 -4.4607 +594 2 13.6638 12.4664 13.5147 0.299935 -1.6824 -0.371902 +595 1 14.5332 9.57639 7.29372 1.70864 -17.4355 -8.36329 +596 2 15.3543 10.0193 7.49698 9.6305 7.8311 1.84335 +597 2 13.8455 10.0241 7.76467 -11.6358 9.67674 12.3645 +598 1 12.6873 16.8129 3.32056 7.83014 22.6359 -6.17069 +599 2 12.905 17.3242 4.12577 -3.6908 -4.91509 -14.526 +600 2 12.6713 17.4548 2.56832 -2.22777 -11.4506 21.1383 +601 1 1.00404 7.03926 17.3541 -3.3312 4.1638 -9.33324 +602 2 0.198847 6.6977 17.7452 -7.86562 1.94891 9.68399 +603 2 0.682364 7.69734 16.7196 12.0745 -4.24482 -2.37704 +604 1 12.9524 4.87174 15.7195 8.90342 0.650689 -3.85785 +605 2 13.7851 4.36673 15.5939 -16.3603 12.0475 7.07164 +606 2 13.1756 5.81397 15.8059 7.81047 -7.07308 -0.568692 +607 1 2.31363 3.41121 5.09984 1.34414 -8.27729 12.6429 +608 2 1.77118 2.94066 5.78541 14.4044 18.7697 -14.1923 +609 2 2.78995 4.15649 5.52715 -11.381 -10.4766 -6.15296 +610 1 8.18617 10.9369 13.7076 0.678078 1.53711 40.2692 +611 2 8.26353 10.8511 14.7174 0.0908521 -0.97824 -49.4206 +612 2 8.97116 10.5326 13.3071 -0.268246 2.83437 5.42064 +613 1 12.9797 1.57395 13.2253 -11.1668 13.2146 -3.30054 +614 2 13.4836 1.606 12.3812 -13.0456 2.80048 17.4401 +615 2 12.3844 2.37352 13.292 24.5144 -24.3843 -9.90982 +616 1 6.623 13.6575 2.08401 -19.1133 11.282 9.3836 +617 2 5.9939 13.9784 2.7781 14.9337 -6.87798 -17.2483 +618 2 7.26745 13.1178 2.55198 -2.04458 -0.845032 2.89429 +619 1 15.8406 6.42424 12.5401 -13.2713 -11.8586 11.2716 +620 2 16.4194 6.98592 12.0445 9.49352 10.2235 -13.5209 +621 2 16.1454 6.51524 13.4484 4.14662 -0.822673 1.52229 +622 1 16.7707 0.701968 9.54479 -0.33564 -15.5889 9.3319 +623 2 16.6398 18.4357 9.88026 3.64558 8.61996 -2.27841 +624 2 16.2643 0.755347 8.72872 -0.899564 4.78829 -7.90839 +625 1 6.16924 11.6733 8.25771 14.6298 -10.0406 -3.26225 +626 2 5.33846 11.3866 8.66461 9.26092 -3.17897 1.03444 +627 2 6.69681 10.8652 8.03849 -20.9756 15.4878 5.14008 +628 1 2.79271 8.6573 0.35403 -23.76 -9.02274 -22.2632 +629 2 2.25448 8.23641 18.2541 16.977 17.0562 34.1458 +630 2 2.21462 9.29512 0.821612 5.57875 -9.71134 -10.0126 +631 1 10.106 10.3292 6.60358 -3.61165 1.9136 -10.2284 +632 2 10.6792 9.71276 7.06962 0.244318 -4.43661 2.14915 +633 2 10.3272 10.2595 5.65755 0.987804 2.37269 11.054 +634 1 6.86896 15.7547 6.74185 -9.45188 0.350857 10.5778 +635 2 7.01957 16.2495 7.56813 1.20841 -3.75655 -8.95365 +636 2 6.86937 16.4078 6.03145 5.97827 -1.66506 -1.56051 +637 1 6.52554 12.9289 5.84178 -0.357514 -5.09084 -2.41361 +638 2 6.62829 13.798 6.2286 3.16894 9.75908 1.28602 +639 2 6.09212 12.3914 6.51525 3.69897 1.96572 0.733322 +640 1 16.7568 12.518 9.72465 -9.23185 -13.2632 0.47822 +641 2 16.902 11.7866 9.09243 0.130969 14.0381 8.74694 +642 2 17.3592 13.2171 9.48659 4.61146 3.47499 -3.98224 +643 1 6.24919 2.86496 2.77119 -11.0856 -12.869 -3.38869 +644 2 6.47325 3.75226 2.51474 6.07925 14.4727 -0.649249 +645 2 5.68088 2.55654 2.04869 4.52067 -4.17334 4.94091 +646 1 10.7277 3.04594 3.24275 -5.68944 3.06595 0.875255 +647 2 10.1765 3.79746 3.50451 2.82785 -3.23936 -2.03517 +648 2 10.278 2.63972 2.48897 0.815959 0.513447 0.723514 +ITEM: TIMESTEP +90 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.787 6.66827 17.9842 -16.1402 -3.16192 1.04025 +2 2 7.92621 6.66814 18.4555 15.1954 -0.455805 -12.5376 +3 2 8.71175 6.0436 17.2441 2.25338 3.19171 10.1252 +4 1 0.22099 8.38854 6.75163 1.7867 -5.58088 53.0968 +5 2 0.258391 8.22026 5.83332 5.30707 -13.3892 -38.1472 +6 2 0.61579 7.61263 7.23543 -10.6686 22.8516 -15.6901 +7 1 8.66795 0.370206 6.9239 18.6241 3.37743 -9.56875 +8 2 9.59619 0.315354 6.61478 -16.3273 1.21351 7.23111 +9 2 8.27983 1.03351 6.33448 -2.90229 -5.54848 4.92815 +10 1 6.43573 1.74596 11.7835 34.1799 -16.6044 -13.764 +11 2 5.93979 2.40996 12.1988 -27.1883 29.6469 18.8725 +12 2 5.80753 1.07598 11.5419 -8.40397 -16.9848 -5.34211 +13 1 6.95318 5.50156 2.37044 -56.4905 40.6357 15.9903 +14 2 6.31995 5.85318 3.09808 38.0444 -22.8427 -29.8317 +15 2 6.63738 6.03683 1.59693 20.7004 -19.4106 17.4304 +16 1 16.2563 10.1963 16.0713 -10.5934 -3.27458 3.94447 +17 2 16.9716 10.3961 15.4827 15.3322 4.9096 -4.70747 +18 2 15.8903 11.0434 16.3496 -2.84586 0.096923 -3.72852 +19 1 10.8156 14.9572 2.29652 -13.5477 -14.1276 -10.2117 +20 2 10.6343 14.4303 3.07787 2.79926 -3.05354 4.26547 +21 2 11.1766 15.7627 2.6355 11.3372 16.7492 6.7502 +22 1 17.2002 8.21443 10.9436 15.2126 5.40823 -8.20499 +23 2 16.6458 8.84622 11.4125 -4.33506 2.62691 -0.328418 +24 2 17.9515 8.74734 10.6145 -8.68143 -7.05886 2.54317 +25 1 14.6067 16.0259 16.3377 27.3765 -5.03456 2.51249 +26 2 13.6996 16.2768 16.4047 -22.3019 9.86517 -5.17321 +27 2 14.7963 15.6285 17.196 -1.96556 -8.36093 -2.03831 +28 1 12.1458 13.2907 0.563101 15.519 -14.4585 7.5186 +29 2 11.8598 13.3671 18.2945 -8.9445 7.51312 -6.12139 +30 2 11.6592 13.8773 1.15113 -3.3891 6.78651 -5.827 +31 1 9.32161 5.49231 3.86239 -40.7454 -0.097831 27.7 +32 2 8.82419 5.45502 4.73277 24.2157 -2.28744 -25.4595 +33 2 8.56838 5.45751 3.23664 18.1191 1.43276 -0.568008 +34 1 1.5546 3.92475 11.5547 -2.15894 45.2634 -4.40984 +35 2 1.55046 4.88574 11.8201 -3.55694 -26.3933 -6.97822 +36 2 1.92957 3.45678 12.2837 10.4321 -13.9157 16.7147 +37 1 2.10319 6.96614 8.15085 -9.44208 -8.37285 -17.308 +38 2 2.4095 7.43328 8.92365 8.57391 0.445975 10.2393 +39 2 2.10294 6.01871 8.3456 1.70875 2.69997 7.84786 +40 1 5.23855 4.482 7.82422 -14.5525 -1.69806 -15.7353 +41 2 5.37847 3.52895 7.72628 3.24739 1.15002 6.52498 +42 2 4.55634 4.7134 7.1559 12.5144 1.33119 10.811 +43 1 3.38552 2.88255 17.3879 -7.38377 33.0145 14.859 +44 2 4.08387 3.35622 16.9066 -6.09174 -4.5148 -0.339366 +45 2 2.81217 3.57956 17.8286 22.0641 -22.8641 -14.398 +46 1 7.5324 5.43864 6.19559 -6.90202 6.90038 35.1799 +47 2 8.08818 5.95892 6.84983 -22.5477 -17.4794 -25.4925 +48 2 6.78022 5.04202 6.71812 26.5249 9.35209 -13.645 +49 1 9.82024 7.03039 12.0775 19.8901 0.0780072 21.9724 +50 2 10.117 6.21395 11.6931 4.07542 -9.22938 -4.80372 +51 2 9.09589 7.30435 11.5485 -23.243 9.22364 -20.0663 +52 1 13.9806 3.7694 8.09667 -19.6388 4.31534 -31.7671 +53 2 13.3819 4.49155 7.81719 15.167 -9.87345 1.12215 +54 2 14.3046 4.00637 8.94223 9.52837 8.93591 30.7953 +55 1 4.52742 17.134 3.88467 -0.450754 13.2049 4.39156 +56 2 5.37483 17.5703 4.13521 -18.32 -2.84079 -10.9512 +57 2 3.94957 17.708 3.32475 23.4139 -10.9615 8.41036 +58 1 16.2726 16.5634 10.552 38.1711 -6.17539 -26.5181 +59 2 15.4837 16.6086 11.0514 -31.396 0.528555 16.213 +60 2 16.0986 15.9648 9.80419 -5.24542 6.81385 7.69127 +61 1 1.94125 4.78402 0.0638345 24.0582 25.3647 11.1071 +62 2 2.62474 5.1599 0.67023 -17.1428 -14.5257 -4.57865 +63 2 1.76164 5.54704 18.141 -7.28608 -7.40463 -3.41134 +64 1 11.2518 13.2771 16.4354 2.60185 -12.9515 -12.3757 +65 2 10.6918 12.4717 16.5304 19.7397 14.6013 -5.52798 +66 2 11.8919 13.1107 15.7025 -16.8897 -0.368153 14.685 +67 1 10.0575 10.919 16.7613 6.16873 -18.0385 3.66167 +68 2 10.4442 10.0133 16.8612 -13.1447 30.924 -0.515142 +69 2 9.09987 10.8482 16.7186 0.711039 -4.16381 0.34444 +70 1 11.8614 17.5086 13.5019 6.48767 -7.71286 -13.5562 +71 2 12.4999 17.0938 12.8959 -9.94411 -4.10313 8.27478 +72 2 12.0757 18.4326 13.4127 -0.0140719 16.2542 2.74368 +73 1 6.39981 9.50139 12.337 -4.6648 -8.8035 -19.3883 +74 2 6.97362 9.2422 11.6012 -0.80266 1.15987 5.77958 +75 2 6.9622 9.95325 12.9581 6.38846 6.66359 6.95977 +76 1 16.2975 12.8974 2.78222 -12.345 -27.8929 4.9875 +77 2 17.1496 13.2141 2.51749 15.349 9.48057 -2.38836 +78 2 15.7502 13.672 2.87844 -10.3717 9.81447 0.854078 +79 1 0.774 12.7819 5.86324 -32.223 -2.64552 -12.7856 +80 2 1.10971 12.9185 4.95432 -4.25214 -7.81578 11.8108 +81 2 18.4306 12.6074 5.76822 36.341 8.50215 1.05579 +82 1 5.29891 16.3721 18.4261 6.47 -16.9938 9.7884 +83 2 5.51669 15.4746 18.1046 -4.53971 18.6444 -2.10572 +84 2 5.85038 16.4657 0.570301 -5.83847 6.29943 -2.02707 +85 1 0.695227 7.70772 4.16735 36.5725 18.4792 -22.7587 +86 2 0.10368 7.96447 3.43723 6.76909 -3.37176 10.733 +87 2 1.60166 8.10351 3.91123 -45.3891 -20.8895 14.9183 +88 1 3.19365 9.10151 6.50287 -37.0597 -13.4257 3.63648 +89 2 3.6513 8.68447 7.23829 0.216969 0.250287 -1.31356 +90 2 2.24726 8.75126 6.54108 37.1121 17.8096 0.286984 +91 1 7.35199 10.4473 16.1779 -19.0362 -10.3824 27.97 +92 2 6.56517 10.9544 15.9216 9.49501 -5.7134 5.26362 +93 2 7.13832 10.0279 17.0488 0.309364 15.3336 -19.7914 +94 1 11.0163 0.890853 5.00632 -3.98909 -12.3472 3.8442 +95 2 10.8807 1.76939 4.61668 6.53092 -8.55309 -4.92776 +96 2 10.738 0.225438 4.34173 2.35985 18.608 2.04389 +97 1 4.21667 2.95093 13.149 10.2014 -19.1015 31.4776 +98 2 4.53515 3.41914 13.9504 -8.71013 -4.86526 -13.316 +99 2 4.15898 1.99936 13.4513 -0.534052 25.4454 -15.6313 +100 1 8.50322 10.2612 1.79208 -4.34668 -17.3092 21.2914 +101 2 8.27549 10.8526 2.5321 5.30441 -1.44182 -6.44774 +102 2 8.58493 9.36982 2.21324 2.85947 21.4101 -9.02924 +103 1 10.3161 1.69184 15.4745 -6.1912 0.342966 -7.58309 +104 2 11.1781 1.38278 15.7166 17.9205 -0.758309 5.87707 +105 2 10.347 1.84648 14.5196 -5.50104 2.18071 3.0962 +106 1 2.60936 12.9662 7.92592 -2.1007 2.96569 -8.82009 +107 2 3.10883 13.7131 7.55922 1.74385 -4.33572 0.675454 +108 2 1.96491 12.7329 7.23617 6.25685 -1.04193 4.90183 +109 1 3.83706 11.6816 4.96058 -22.5573 -14.4893 8.95363 +110 2 3.56827 11.1846 5.76493 10.0033 8.11351 -16.9036 +111 2 3.08816 11.5736 4.33469 10.7007 11.5305 11.906 +112 1 6.6582 14.5337 16.9912 3.19916 -10.5164 -7.18554 +113 2 7.36558 15.1576 17.1605 2.12516 -0.469731 1.77687 +114 2 6.47854 14.5937 16.0445 -2.82585 4.49818 1.60201 +115 1 14.2037 14.4903 3.21857 16.956 -7.57282 -16.8086 +116 2 13.9492 15.374 3.44691 -9.21692 15.261 -0.929302 +117 2 13.8764 13.9351 3.91269 -8.69982 -10.6193 13.7942 +118 1 8.69855 18.0357 16.1264 41.5507 -6.08144 10.5978 +119 2 9.33855 17.4056 16.5195 -30.3672 -5.67283 -6.86348 +120 2 9.34419 0.0405339 15.8183 -19.2067 16.0047 -5.03817 +121 1 4.69307 1.79842 4.89677 16.2385 30.5389 -26.6001 +122 2 3.80396 2.19318 4.80489 14.8244 -2.46841 6.40587 +123 2 5.29999 2.32882 4.27745 -28.5893 -25.5208 24.7929 +124 1 15.0277 12.5795 16.5521 32.6678 1.07726 26.51 +125 2 14.723 12.7481 17.4682 -6.07814 3.10734 -21.8061 +126 2 14.3421 12.5499 15.8992 -22.7964 0.862239 -7.92322 +127 1 15.7044 18.5089 16.8468 26.9219 -3.0014 45.6431 +128 2 16.268 18.6119 17.6883 -20.0241 -2.05323 -42.0683 +129 2 15.5234 17.5608 16.7959 -6.5303 3.1055 -1.70461 +130 1 1.37672 1.34924 16.652 -10.0314 2.12664 3.94932 +131 2 2.13238 1.94076 16.8287 -14.5592 -12.7899 -0.0819953 +132 2 0.657997 1.59844 17.2733 17.8805 -0.89879 -9.33461 +133 1 18.2331 4.34642 15.9005 -0.884234 -3.04582 -21.1642 +134 2 17.8346 3.73179 15.2509 9.01129 10.3034 11.7071 +135 2 0.449037 4.61451 15.5361 -9.49368 -5.77709 6.1071 +136 1 12.1007 17.0847 16.1341 -21.8736 -13.8645 50.4236 +137 2 11.3773 16.6353 16.6829 29.7152 15.2039 -30.2146 +138 2 11.8045 17.1565 15.2358 -4.92233 -3.24187 -16.5992 +139 1 16.1203 2.66556 18.245 -33.6191 11.8512 -24.8852 +140 2 15.5683 3.39571 18.6154 19.5646 -10.4389 -9.45588 +141 2 15.8602 2.60471 17.2935 4.4965 0.524143 22.3318 +142 1 6.68711 13.7575 10.0686 6.57394 0.780895 15.4701 +143 2 6.65896 13.3749 10.963 -3.37269 2.77311 -6.77332 +144 2 6.71723 13.0193 9.46247 -3.0919 -8.05072 -6.49535 +145 1 10.1832 18.4638 2.68288 15.4984 11.1175 -14.1442 +146 2 10.4797 0.410785 1.94548 -7.56539 -13.8801 19.3089 +147 2 9.29042 18.2071 2.48382 -12.5464 -2.66261 -5.58966 +148 1 3.06565 17.654 6.19973 -11.4817 2.82915 -15.5316 +149 2 2.17867 17.6912 5.79869 7.15707 -3.68965 15.0105 +150 2 3.60434 17.7569 5.40979 11.429 -4.57556 5.13078 +151 1 12.6359 16.7831 7.87678 -34.4323 5.42099 5.88286 +152 2 11.8215 16.2589 7.70694 19.4452 0.972157 -0.554869 +153 2 12.3283 17.4377 8.53506 12.9634 -4.48143 -6.06952 +154 1 14.8812 15.2555 8.26349 -9.13488 6.23831 13.721 +155 2 14.2179 15.9485 8.09528 6.25869 -7.42326 0.874894 +156 2 15.4123 15.1764 7.46942 0.572987 8.13089 -2.89012 +157 1 17.8363 18.2748 0.235726 -36.9104 2.14965 -2.72595 +158 2 18.5544 17.6878 0.132306 25.4932 -25.6882 -8.95291 +159 2 18.2375 0.371142 0.648791 5.78715 27.9621 12.2792 +160 1 0.76648 10.5228 1.42349 -23.6052 -44.6853 36.9297 +161 2 -0.0625164 10.0248 1.72181 36.7073 15.4552 -13.6362 +162 2 0.483164 11.1861 0.82966 -10.4498 25.872 -24.2739 +163 1 1.81496 12.3027 3.28068 4.06427 7.40541 18.1542 +164 2 1.38036 11.6556 2.74613 -8.62838 -16.0879 -14.4133 +165 2 2.12935 12.9782 2.6808 0.203437 6.54347 -1.70293 +166 1 0.715096 17.2857 4.99328 6.02973 16.9927 -22.851 +167 2 -0.0549074 17.8034 5.17132 -8.63108 24.1627 -3.07112 +168 2 0.561936 16.5317 5.51148 1.70853 -39.3498 23.4345 +169 1 1.0126 0.815092 9.34853 9.77893 1.05612 10.9097 +170 2 1.24172 0.537916 10.2451 4.93082 3.28815 4.21298 +171 2 0.133534 0.483606 9.24599 -18.3012 -2.93221 -7.23643 +172 1 16.7899 2.36695 13.4143 1.34336 11.0529 -24.546 +173 2 16.9036 2.71504 12.491 -0.235106 -7.90147 26.8103 +174 2 16.4417 1.47344 13.309 3.25474 -1.82726 5.59598 +175 1 2.66167 16.0077 12.0598 12.6303 -22.6944 6.71055 +176 2 3.01062 15.6298 12.8947 -8.01809 9.38789 -15.4913 +177 2 3.11281 15.5097 11.3415 -7.7677 12.8204 10.8964 +178 1 16.364 15.512 6.14932 19.0855 9.58845 -19.9598 +179 2 17.3177 15.4404 6.40388 -23.0707 9.20906 -7.80583 +180 2 16.2465 16.2844 5.52559 8.28806 -24.9431 19.8586 +181 1 5.77951 5.20043 11.8033 8.47507 -20.9263 -15.707 +182 2 5.6405 6.00993 12.2754 -6.27864 14.793 10.9641 +183 2 5.18835 4.5564 12.2066 -2.11002 -1.11499 -2.91817 +184 1 15.1794 4.92089 0.775894 -18.0102 -8.76269 31.4284 +185 2 14.9497 4.67568 1.72392 8.26683 8.97624 -32.6089 +186 2 14.3636 5.23769 0.366515 4.70525 -0.664057 3.69432 +187 1 16.3975 16.4382 1.83859 15.8969 -1.83249 -31.9545 +188 2 16.3175 16.7184 2.73629 -8.02889 11.6848 21.5541 +189 2 16.8259 17.1655 1.34034 -8.03244 -7.80667 10.4102 +190 1 0.153841 4.83744 3.963 18.3567 41.8245 -8.83163 +191 2 0.481764 5.78512 3.86014 -17.0028 -34.1388 7.97498 +192 2 0.952119 4.32423 4.11352 -0.77715 -2.59924 4.82879 +193 1 2.94647 15.0748 15.1079 -17.5423 -9.74792 39.2804 +194 2 2.84668 14.6538 16.0052 7.88621 4.55617 -28.9019 +195 2 2.37581 15.8415 15.2342 5.36547 9.02165 -11.4736 +196 1 1.04118 14.6398 9.41517 21.0794 -20.4815 -17.0137 +197 2 1.63478 13.9208 9.06194 -19.3512 25.5288 8.96267 +198 2 0.7851 14.3144 10.2695 -7.28135 -4.68142 11.1743 +199 1 13.5343 16.512 11.5541 0.415781 17.9887 -13.1724 +200 2 13.2087 17.3014 11.0493 5.42519 -19.6136 10.4452 +201 2 13.1525 15.7431 11.1062 -5.37134 4.1326 5.42785 +202 1 4.79073 1.57335 0.678685 -10.2425 -16.6589 -0.602312 +203 2 4.2243 2.02466 0.0269211 5.06007 -3.50169 9.95598 +204 2 4.26355 0.829094 1.04695 5.40097 16.8315 -2.73739 +205 1 1.55169 18.6011 11.9401 -14.2618 14.3088 -13.4455 +206 2 1.54559 0.423493 12.7773 -0.760074 5.21042 2.72529 +207 2 2.10509 17.8447 12.0596 11.7149 -17.0814 4.30068 +208 1 11.3926 10.0859 4.15406 35.1149 20.4659 -18.5884 +209 2 11.4922 10.6036 3.30306 -8.07316 -21.3073 26.3838 +210 2 12.3257 9.94393 4.45754 -25.8381 1.71308 -8.95455 +211 1 8.18732 12.2257 3.75704 -12.727 -0.351394 27.2441 +212 2 9.08394 12.5468 4.00553 -19.5779 -3.96369 2.83586 +213 2 7.55786 12.2705 4.55735 35.1927 2.13842 -31.3906 +214 1 14.6183 4.0143 3.36201 13.432 11.2186 16.7224 +215 2 15.2472 4.27703 4.07585 -12.4329 -9.47893 -15.9273 +216 2 13.7521 4.30159 3.67007 -0.91716 0.860244 -2.07153 +217 1 5.73358 1.67843 7.60794 -24.3615 -22.8066 38.6551 +218 2 5.03202 1.06037 7.9982 26.7251 29.011 -15.8684 +219 2 5.4689 1.83957 6.71483 -6.40801 -4.86943 -26.9957 +220 1 17.8709 0.966847 4.84319 9.19834 18.9135 -13.8104 +221 2 18.365 1.30942 4.06688 -7.16187 -11.4028 13.2983 +222 2 17.8528 1.72071 5.45189 -4.56365 -9.98849 0.137087 +223 1 6.8232 9.21412 4.53503 0.0591715 -6.07859 -16.7729 +224 2 6.61803 9.33533 5.45725 2.71524 4.28405 13.1117 +225 2 7.76963 9.02928 4.48077 0.0640272 -1.66157 1.55662 +226 1 2.43776 14.707 2.05519 12.3789 -12.7502 -17.0618 +227 2 3.26162 14.6424 2.56361 -5.44595 2.48516 -0.426941 +228 2 2.66563 14.4192 1.14611 -3.66427 9.22898 15.3942 +229 1 17.2291 12.9271 13.0675 -25.7945 34.5425 2.40746 +230 2 16.3582 13.328 13.3279 21.6203 -16.0155 -5.62376 +231 2 17.7378 13.7209 12.8173 -0.837652 -12.191 -0.563337 +232 1 14.8245 10.5613 1.47762 -19.5687 -28.1113 -12.7998 +233 2 15.3117 11.2776 1.82539 19.2978 30.1093 14.6064 +234 2 13.9052 10.723 1.70642 0.475408 2.13461 -1.67485 +235 1 5.64982 6.63563 4.55084 7.38671 -15.2963 15.0755 +236 2 5.89214 7.54949 4.44479 2.16454 16.7651 -4.4857 +237 2 6.3044 6.30345 5.19757 -6.24708 1.07556 -9.93912 +238 1 8.10845 8.3271 10.3627 -2.57156 5.78827 13.3728 +239 2 8.61892 8.85799 9.7482 5.06505 3.86155 0.738683 +240 2 7.30116 8.09886 9.91192 -6.7312 -10.1116 -10.9746 +241 1 13.4488 18.4608 5.65963 -13.3307 -19.6223 8.99938 +242 2 12.6096 0.239632 5.39678 7.81848 3.10411 6.37483 +243 2 13.1935 17.7385 6.2846 5.11891 19.4349 -8.45882 +244 1 -0.00278136 2.5625 0.408955 -12.183 35.1922 -19.112 +245 2 17.7147 2.60224 18.7259 18.9642 -9.11891 12.7486 +246 2 0.290302 3.48872 0.227759 6.22068 -26.2608 7.60118 +247 1 12.9842 10.8497 9.70117 -72.6257 27.1129 -13.2266 +248 2 11.97 10.965 9.69449 48.4921 6.31007 0.109369 +249 2 13.0048 9.91956 9.83068 16.3628 -25.292 6.36111 +250 1 0.548273 12.2593 11.2103 29.2233 3.63314 -8.31727 +251 2 18.2651 12.1894 11.4198 -11.8267 3.42799 7.99272 +252 2 1.06577 12.5175 11.9926 -12.6507 -2.71608 -2.06856 +253 1 5.24515 7.35168 13.3154 -11.9716 -5.94003 -7.6844 +254 2 5.73604 8.07931 12.9223 2.64227 5.43904 4.60776 +255 2 5.63818 7.16239 14.1672 7.7875 0.124539 4.29694 +256 1 1.16856 6.76355 12.0035 -37.5881 -40.6251 -19.8542 +257 2 0.334741 7.08942 11.6206 8.86965 -4.87383 5.4559 +258 2 1.63397 7.52151 12.2381 28.649 45.7996 14.9133 +259 1 15.5501 9.75639 12.3967 -1.92883 21.1886 15.8166 +260 2 15.1116 10.6344 12.221 21.3449 -31.3991 6.12972 +261 2 16.0605 9.85526 13.2245 -13.7753 0.465455 -14.4819 +262 1 16.5858 12.6354 5.59083 -2.62715 14.8355 -19.0185 +263 2 16.4437 13.5882 5.83081 0.436603 -22.1434 -16.2318 +264 2 16.416 12.5171 4.60718 5.48378 12.0784 33.3147 +265 1 6.40279 9.86277 0.0794915 -20.3924 -8.41649 -9.56759 +266 2 5.55524 10.218 0.380594 4.23452 2.32222 -1.66862 +267 2 7.0555 10.2042 0.674211 16.128 4.48978 14.4774 +268 1 12.2427 6.01171 4.00399 -23.1281 -36.6346 24.2315 +269 2 12.2798 6.64894 3.31747 0.117026 23.2517 -16.0656 +270 2 11.2984 5.74139 4.08171 19.6095 7.84283 -4.73597 +271 1 0.360057 12.9056 0.031807 -8.11921 2.1908 5.08387 +272 2 18.8977 13.4796 0.805411 -3.72305 -1.59029 -3.55744 +273 2 18.3786 13.2516 18.0169 7.85083 -4.92073 3.80969 +274 1 3.55677 18.7152 8.66247 19.9063 -6.335 -5.44295 +275 2 3.49677 18.1902 7.8473 -5.97778 6.84736 4.02201 +276 2 2.66917 0.348355 8.87781 -8.06089 0.921211 -3.36616 +277 1 7.26214 17.4262 4.43744 19.2672 26.0801 -3.30237 +278 2 7.75433 18.2474 4.74147 -22.4281 -27.0983 -14.818 +279 2 7.37471 17.3728 3.46226 -1.25032 2.03681 18.5343 +280 1 9.25258 17.1703 12.1759 28.8617 -14.1678 9.07352 +281 2 9.26958 16.3393 11.6513 -2.57153 16.4076 7.11435 +282 2 10.1283 17.1978 12.6604 -29.6357 0.448077 -14.593 +283 1 13.2677 13.193 7.99719 -21.1722 -32.5843 10.0566 +284 2 13.3388 12.6042 8.77917 0.104276 5.764 -17.169 +285 2 13.8077 13.9427 8.17139 23.4211 18.1414 5.93605 +286 1 14.7593 2.91325 15.4943 24.3728 -2.49696 -23.5999 +287 2 14.0361 2.3713 15.1546 2.238 -3.60609 4.01929 +288 2 15.4274 2.94021 14.7667 -15.6113 -2.56038 15.0831 +289 1 9.9738 15.6484 16.9671 -8.54083 0.59912 -5.05632 +290 2 10.1057 14.7848 16.5569 10.1368 1.85589 1.18764 +291 2 9.46144 15.457 17.7506 -1.80616 -1.66933 10.9911 +292 1 11.2344 8.55758 16.6355 7.77426 1.92795 -6.45244 +293 2 10.4646 8.11257 16.295 -8.96701 -9.58703 -5.10609 +294 2 11.6991 7.91388 17.1598 3.61158 -8.68538 8.99751 +295 1 4.14955 18.3179 16.8036 -6.71252 9.00681 -6.36217 +296 2 4.47312 17.6803 17.4466 6.33314 0.74429 2.85153 +297 2 4.24503 0.569095 17.1648 -0.42517 -11.8307 0.148866 +298 1 2.33957 4.29184 8.91302 22.2448 -7.34702 27.8454 +299 2 3.30686 4.08394 8.81247 -29.123 7.66299 4.05924 +300 2 2.12598 4.16624 9.8839 8.54186 0.354435 -34.7065 +301 1 9.95255 10.4179 9.8571 -18.8164 27.0404 -12.2944 +302 2 9.4534 11.1894 9.4744 17.3372 -21.5482 9.10503 +303 2 9.8309 10.4683 10.8129 6.92766 -2.76642 -0.156957 +304 1 9.80127 0.922938 10.8108 4.3272 3.59983 6.04006 +305 2 9.35046 0.175669 11.2139 0.840012 -6.18623 1.13214 +306 2 9.1369 1.38463 10.2905 0.460774 -0.831922 -5.90435 +307 1 9.16459 15.1765 10.2101 -26.8722 -7.06493 -21.2153 +308 2 8.97785 15.8968 9.57551 3.0406 -6.31351 13.2231 +309 2 8.39419 14.5643 10.0571 23.5779 16.7742 11.4525 +310 1 0.773683 9.7544 10.1833 18.261 11.1305 -23.2394 +311 2 0.868202 10.7262 10.3345 -3.82315 -24.612 -0.100636 +312 2 1.30536 9.53677 9.37727 -17.4146 8.84667 24.1623 +313 1 17.2096 4.87642 8.04469 -12.9959 -9.21067 35.1395 +314 2 16.3347 5.16277 8.3943 19.7751 -0.094318 -9.55648 +315 2 17.6197 4.3572 8.78272 -10.3132 11.9302 -24.4143 +316 1 14.8095 14.6496 0.0373288 -5.69372 -9.04424 21.9283 +317 2 15.5101 14.9524 0.640087 -10.906 0.748239 -2.66247 +318 2 14.0769 14.3265 0.613297 14.425 8.36295 -12.6903 +319 1 3.89537 11.0996 9.55593 -9.82967 16.3938 -0.398364 +320 2 3.93242 11.2996 10.5001 -1.21387 -1.78602 1.5381 +321 2 3.39392 11.8407 9.15947 5.2768 -13.1919 0.569667 +322 1 11.4169 10.7371 1.49225 5.47317 24.4145 -6.81884 +323 2 11.5532 11.6314 1.08329 0.074839 -23.6179 10.2373 +324 2 10.4618 10.6109 1.50924 -1.9569 -1.96948 -2.8184 +325 1 13.1395 7.21524 12.5729 -20.455 -7.16835 0.858137 +326 2 14.0577 7.03675 12.4308 23.1896 -1.74136 0.0778831 +327 2 12.7378 6.3322 12.608 -1.47964 6.92135 2.9072 +328 1 9.65614 1.96645 0.86496 18.1931 4.09637 20.8777 +329 2 8.84682 1.67677 0.484793 -23.8326 -3.90796 -8.97572 +330 2 10.1746 2.31935 0.150168 8.91513 5.01659 -9.40528 +331 1 10.6386 13.4197 4.53193 2.28663 -4.65747 18.8344 +332 2 11.4948 12.9639 4.69275 -16.1918 12.7288 -0.469196 +333 2 10.3958 13.8423 5.38242 9.30576 -5.17735 -13.1714 +334 1 14.5273 1.57884 10.9459 15.1221 22.4117 -0.776229 +335 2 15.362 1.31139 10.5257 -10.7732 -5.17355 3.70166 +336 2 14.6474 2.54531 11.0746 -6.11584 -12.5888 -6.32845 +337 1 14.4766 12.0159 11.6273 -10.9263 4.56586 -44.1867 +338 2 15.2047 12.4077 11.0864 -12.0042 -9.95663 15.0185 +339 2 13.8634 11.5981 10.9451 22.3117 17.3775 30.6101 +340 1 8.16847 5.14124 9.81669 -29.5484 17.7318 23.7918 +341 2 7.27475 5.12719 10.2684 30.6512 -1.40914 -16.6308 +342 2 8.33799 4.26267 9.50012 -3.06916 -18.2431 -3.24008 +343 1 1.5108 16.9662 18.5044 9.55151 26.7901 -23.2493 +344 2 1.84435 17.2897 17.6363 -7.76754 -5.77411 19.656 +345 2 1.83481 16.0826 18.5596 5.96378 -22.3257 1.76596 +346 1 1.42717 17.3886 15.3379 47.0554 -13.0927 -7.45492 +347 2 1.50543 18.1882 15.8264 3.14075 27.3625 12.617 +348 2 0.523906 17.2066 15.2924 -49.7083 -12.5335 -2.74225 +349 1 3.49173 5.73723 6.04987 -5.63889 12.5308 6.32322 +350 2 3.05134 6.46754 6.5425 11.5005 -15.9447 -9.63575 +351 2 4.14223 6.14285 5.45548 -4.8412 1.1033 3.2125 +352 1 12.5916 9.51872 14.2408 10.4293 -27.0271 -12.8548 +353 2 13.028 8.79356 13.6831 -19.628 26.0366 30.4849 +354 2 12.3513 9.14884 15.1174 6.55215 0.813797 -17.5332 +355 1 4.09544 15.2089 7.12218 31.8609 13.6269 2.32941 +356 2 3.67616 16.0257 6.80924 -1.84113 -5.17266 1.34804 +357 2 5.07546 15.4284 7.13078 -32.8392 -10.6488 -3.17146 +358 1 0.799143 8.79431 15.1488 8.21516 12.8732 -16.9375 +359 2 0.575284 9.7423 15.0796 -2.5473 -12.0602 5.3867 +360 2 1.52676 8.70151 14.5038 -8.32138 -2.51513 8.31525 +361 1 12.8725 8.28632 10.0993 13.5644 -10.3417 -12.785 +362 2 13.6812 7.81606 9.78663 -13.8637 7.80766 13.5238 +363 2 12.7502 8.10095 11.0322 6.24745 -8.27276 5.3213 +364 1 15.2423 7.98405 3.44353 15.6799 19.5655 -11.9659 +365 2 14.4463 7.83544 2.89643 5.54982 -16.2362 17.4101 +366 2 15.5184 7.39607 4.17406 -22.72 2.15229 -11.0841 +367 1 17.1687 6.76019 0.0376092 -10.314 6.5713 -12.413 +368 2 16.7239 5.93548 0.292072 -0.0664332 9.88195 -1.29815 +369 2 16.4741 7.34647 18.2846 16.8516 -16.4801 16.1304 +370 1 8.96925 6.98328 7.86383 -27.8745 -15.8066 22.0328 +371 2 9.86939 7.24269 7.81058 30.3142 9.1639 -3.03437 +372 2 8.87474 6.48936 8.713 -1.39219 10.6855 -19.1169 +373 1 12.482 0.614891 1.23015 1.92335 -8.70167 1.10105 +374 2 13.2432 1.03802 1.64803 2.06157 -2.24376 -3.30204 +375 2 12.803 0.16068 0.442821 -0.913907 6.47573 3.0001 +376 1 5.66871 15.0647 14.4598 7.14191 19.2454 -5.51099 +377 2 4.75956 15.0903 14.7907 1.11348 4.01334 -3.77227 +378 2 5.94804 16.0038 14.294 -6.0872 -24.4911 3.70117 +379 1 3.73529 6.48244 1.70347 -4.32476 7.10488 -19.4811 +380 2 3.3805 7.26573 1.22404 3.0021 -10.505 14.7125 +381 2 3.73285 6.71028 2.6365 -0.71904 4.06656 1.73817 +382 1 3.86925 11.322 12.3296 2.55777 5.65869 0.326193 +383 2 4.7048 11.7602 12.5386 0.0734552 -4.93202 -1.70743 +384 2 3.20028 11.8652 12.7549 -2.96009 3.18005 0.676376 +385 1 5.3196 3.88545 15.7107 -12.565 72.4648 14.1271 +386 2 6.00107 3.31 15.4478 35.5939 -28.3589 -8.92722 +387 2 5.74724 4.80358 15.8116 -17.6513 -43.1362 -7.7855 +388 1 14.0258 10.1309 4.70784 36.378 -19.982 -23.5474 +389 2 14.2654 9.87929 5.60631 -3.02994 -1.07275 0.485782 +390 2 14.6765 9.60938 4.12831 -34.5421 20.7478 23.7761 +391 1 7.50853 17.298 8.98976 4.28677 22.6193 13.4416 +392 2 7.01472 17.6504 9.76182 0.935323 -12.9311 -15.6818 +393 2 7.87431 18.0869 8.55212 -1.49272 -9.54271 -2.09709 +394 1 4.57424 14.4015 3.77738 -1.32578 6.84514 50.6918 +395 2 4.51443 15.3073 4.2079 4.46262 -31.6709 -20.6737 +396 2 4.58351 13.7394 4.53798 -1.39317 23.0513 -31.5206 +397 1 14.2431 7.32994 15.8885 26.8814 9.55229 5.02737 +398 2 15.048 7.31796 15.3145 -19.1816 0.583054 17.9404 +399 2 14.5184 7.8184 16.7026 -8.00009 -12.2304 -19.9762 +400 1 3.00564 18.4171 1.98737 1.19435 35.3283 33.2576 +401 2 2.60973 17.9491 1.28647 -18.7059 -24.7202 -27.1582 +402 2 2.28625 0.311703 2.39571 15.2164 -11.2621 -13.5372 +403 1 7.97098 1.60459 4.54116 29.2267 3.13781 -13.0843 +404 2 7.39603 1.96083 3.86318 -8.15365 2.40339 -0.697123 +405 2 8.86388 1.74438 4.1564 -17.9094 -5.03071 12.9608 +406 1 2.50155 14.1648 17.7228 -14.4362 -20.2086 14.4505 +407 2 1.80023 13.5192 18.0233 22.5798 22.6486 -13.5864 +408 2 3.34474 13.7188 17.8802 2.38023 -0.79805 1.89101 +409 1 0.962462 1.97628 13.8796 24.0866 5.42438 -18.2963 +410 2 1.23331 1.73159 14.7528 2.00372 -3.67266 20.967 +411 2 0.0219615 1.96156 13.879 -26.3344 -0.788872 -2.58417 +412 1 4.34962 0.156713 13.8729 25.4477 -1.51409 -1.97896 +413 2 5.30295 18.5478 13.9084 -21.2168 3.6137 -4.76321 +414 2 3.99528 18.4902 14.7051 -3.29088 -0.042535 8.53213 +415 1 7.35889 1.01117 18.4602 -20.0845 2.29217 31.534 +416 2 7.53777 0.614221 17.6282 1.02155 -13.8743 -28.1328 +417 2 6.39885 0.929085 18.6632 17.4429 7.83311 -8.37388 +418 1 15.8463 18.3909 13.9448 -43.3072 10.6601 -1.92517 +419 2 14.916 18.6906 13.7723 29.0574 -10.6436 -1.66619 +420 2 15.8257 -0.445507 14.8871 10.2412 6.45473 0.424587 +421 1 10.2808 4.63783 16.2194 -42.4572 -26.934 -19.6441 +422 2 11.2059 4.65809 16.3645 33.0638 0.71496 4.62375 +423 2 10.0964 3.70704 15.9214 4.59595 26.5122 11.6188 +424 1 15.903 17.6519 4.47823 -22.6026 32.3058 18.5214 +425 2 16.5145 18.4189 4.46111 -7.58873 -12.9749 2.84853 +426 2 15.0701 18.0221 4.91498 30.26 -18.095 -22.6862 +427 1 6.91987 17.5654 13.9309 41.5981 2.12242 13.325 +428 2 7.49428 17.7119 14.7497 -22.2257 -6.74767 -31.4029 +429 2 7.56851 17.4237 13.1898 -17.2813 4.26485 21.283 +430 1 13.2143 6.40362 6.52296 -17.8609 -7.45559 2.6451 +431 2 14.0836 6.75111 6.37132 17.2928 3.48546 -1.85822 +432 2 12.8363 6.25317 5.64277 2.90235 4.29902 5.97585 +433 1 7.86013 2.26394 9.49062 -8.36252 -9.46169 -35.4407 +434 2 7.29684 2.1706 10.2513 -11.7917 -0.851936 13.7299 +435 2 7.34714 1.87564 8.72892 15.7155 15.0955 20.8405 +436 1 15.1343 14.8378 13.7575 -15.8142 13.0315 4.83039 +437 2 14.8532 15.0481 14.6708 3.35379 -3.45087 -12.098 +438 2 14.5629 15.3828 13.1802 11.493 -9.40285 7.27009 +439 1 9.38118 8.39884 3.83519 4.0123 -7.74443 -2.87465 +440 2 10.2467 8.83344 3.97294 -13.6344 -10.1795 -2.34121 +441 2 9.51993 7.43201 3.84247 0.270426 14.3255 0.324032 +442 1 17.6982 13.5806 16.4882 -11.1823 29.4115 -15.1875 +443 2 16.7477 13.4163 16.452 -1.16521 -4.14372 2.83933 +444 2 17.7994 14.4458 16.0124 3.95943 -25.1425 10.6502 +445 1 4.93057 10.3937 2.82949 21.3493 0.31084 -7.87351 +446 2 5.82872 10.0425 3.0149 -20.5327 4.11374 3.5741 +447 2 4.70497 10.9363 3.59521 3.63155 -1.89772 -0.291932 +448 1 3.65557 8.40975 9.92882 -7.92631 -13.4411 16.4299 +449 2 3.66668 9.34394 9.72247 1.00161 8.70404 1.26029 +450 2 3.36367 8.33438 10.8592 4.36465 5.8519 -13.4993 +451 1 15.9508 6.91708 5.85912 26.4071 -7.62551 -3.83966 +452 2 16.729 7.34279 6.26867 -14.5536 -3.6129 -4.6023 +453 2 16.2929 6.05819 5.53033 -12.7649 13.2481 9.54942 +454 1 15.2478 7.26488 8.9948 -11.5397 21.0457 -23.7706 +455 2 16.0349 7.57374 9.47019 -5.83 4.16597 -2.61919 +456 2 14.9977 7.92652 8.27445 16.2337 -23.38 28.7542 +457 1 6.17715 12.7863 12.74 7.06624 23.8889 14.8517 +458 2 6.98998 12.4152 13.1111 -3.934 -5.41615 -1.6338 +459 2 6.02064 13.6181 13.2483 1.6805 -16.267 -10.1818 +460 1 12.1255 4.53395 13.1266 36.5984 28.8141 18.352 +461 2 12.1988 4.68857 14.088 4.72218 -0.985297 -9.83354 +462 2 11.344 4.04995 13.0228 -42.0246 -23.4808 -8.79261 +463 1 11.4542 8.08345 7.86287 23.2187 -10.867 14.4494 +464 2 12.2022 7.55078 7.50013 -20.6002 10.1652 -0.104446 +465 2 11.6749 8.16233 8.821 -5.77941 1.62242 -23.2927 +466 1 16.9966 10.8 7.60022 14.0465 -17.3895 -10.8701 +467 2 17.6655 10.1188 7.31004 -18.6815 22.6831 6.1404 +468 2 16.8855 11.476 6.90625 3.56282 -12.242 0.823841 +469 1 5.28409 18.0615 10.7272 -25.4136 -4.73004 -4.09376 +470 2 4.85025 17.4105 11.3211 10.0924 14.2936 -14.0097 +471 2 4.61921 18.235 10.0106 18.3134 -6.11244 18.1083 +472 1 7.63344 17.4775 1.60819 -12.3126 -2.35291 35.094 +473 2 8.06049 16.702 1.26786 10.3266 -12.472 -14.3961 +474 2 7.64482 18.174 0.971148 2.96613 14.6858 -21.2308 +475 1 1.92556 12.9088 13.6099 -6.92879 6.84011 17.0322 +476 2 1.40166 12.3078 14.1747 6.51182 9.66465 -5.96466 +477 2 2.01688 13.7519 14.1152 3.80073 -20.221 -11.3532 +478 1 9.32296 6.74742 14.7603 -6.16505 19.9578 -6.21839 +479 2 9.80961 6.04203 15.1542 10.8193 -23.4577 14.2182 +480 2 9.81429 6.97553 13.9666 -4.58884 0.0213979 -5.59057 +481 1 15.2687 4.29028 10.7744 -16.6773 -11.1812 -9.87371 +482 2 16.185 4.03181 10.6852 9.89086 1.55812 4.86514 +483 2 15.2046 4.88146 11.5266 6.28069 5.56792 1.9642 +484 1 11.3833 6.23863 0.0689293 -3.19885 -6.29427 4.65322 +485 2 11.5449 5.27036 18.7473 -10.1654 17.1623 -6.02864 +486 2 10.4171 6.41156 18.6664 16.019 -11.974 -2.10863 +487 1 18.4779 11.4738 14.9298 -4.11302 6.12113 -30.5228 +488 2 18.0937 12.0014 14.1715 8.36132 -18.8326 26.0479 +489 2 18.3027 12.0103 15.7035 0.536699 7.83234 4.13522 +490 1 7.03799 9.27423 7.33397 -11.8444 -18.9096 15.35 +491 2 6.61404 8.50211 7.787 12.2323 17.6714 -16.3801 +492 2 7.97664 9.07639 7.31215 4.33333 -2.45816 -2.54611 +493 1 18.3885 15.3347 12.1965 11.3664 3.9942 -3.56245 +494 2 0.676524 15.5664 11.9851 -14.9026 2.39255 4.26485 +495 2 17.8062 15.8491 11.6143 4.55299 -1.04774 1.98359 +496 1 16.551 4.342 5.30396 -29.3567 -2.30965 40.8017 +497 2 16.5003 4.35995 6.30392 8.99046 -4.55546 -31.3189 +498 2 17.4312 4.58446 5.06774 26.2551 1.0485 -9.7407 +499 1 17.7614 3.18175 10.7726 14.454 -1.68376 5.55906 +500 2 18.6848 3.25815 11.0867 -17.2868 6.635 -4.74284 +501 2 17.731 2.30667 10.3896 -4.78084 -7.5669 -7.23363 +502 1 12.3288 18.6185 10.0887 4.81564 48.0444 9.66027 +503 2 11.5224 0.4701 10.402 18.5752 -22.9317 -12.6203 +504 2 13.04 0.683861 10.1001 -20.831 -28.6711 -0.571217 +505 1 10.4023 9.75891 12.5069 9.56908 10.7357 22.5843 +506 2 11.0968 9.84844 13.1991 -9.82495 1.00858 -15.0243 +507 2 10.3005 8.81694 12.4067 -0.389825 -11.0581 -5.16736 +508 1 0.728244 2.62509 7.20528 10.511 21.9286 8.67284 +509 2 1.10851 3.44304 7.59367 -9.47208 -14.047 -5.98037 +510 2 0.946108 1.9669 7.86838 0.119732 -6.07738 -1.41007 +511 1 0.301432 15.3195 6.88989 15.9737 -48.0831 -14.5816 +512 2 0.502768 15.5752 7.7858 2.08568 -2.79341 12.7124 +513 2 0.620951 14.3521 6.81024 -17.8336 49.2232 -1.9498 +514 1 17.0496 6.91172 14.9593 8.8057 -4.67917 1.70395 +515 2 17.812 7.50707 14.8676 -6.01141 -3.19386 0.836122 +516 2 17.3983 6.09137 15.355 -4.50622 8.29661 -2.9861 +517 1 9.11865 12.5108 8.02933 -49.9881 -7.42173 -16.2711 +518 2 9.47674 11.8107 7.47486 8.95817 -5.21768 -2.38673 +519 2 8.15231 12.5395 7.74329 38.6911 2.79466 15.4325 +520 1 1.1334 1.67756 2.81686 3.27117 15.7614 -6.58164 +521 2 0.957986 2.31477 2.10151 -6.66947 -14.3695 3.78127 +522 2 1.78538 2.12055 3.36586 -0.578909 1.22693 6.40118 +523 1 4.20106 15.0562 10.0364 -13.4085 1.18971 -5.18923 +524 2 3.93003 15.0868 9.10675 3.70212 3.27773 4.96515 +525 2 5.05647 14.6363 10.0432 10.3336 -3.36269 -1.32379 +526 1 7.40784 2.22679 14.822 -4.38879 4.63456 3.27925 +527 2 7.05629 1.62422 14.1639 1.19517 -1.6595 -3.72526 +528 2 7.83793 2.94849 14.3413 -6.72155 -4.85002 1.32971 +529 1 18.3301 14.5327 2.1542 24.8671 -25.4621 4.78212 +530 2 0.57397 14.7195 2.50861 -8.4973 4.51839 -6.64425 +531 2 17.8578 15.3422 2.05909 -12.5294 22.9533 -1.13776 +532 1 10.0489 2.71902 12.9028 6.85621 -14.8278 -12.6664 +533 2 9.96638 2.08865 12.1549 1.47254 10.1846 11.5218 +534 2 9.24995 3.25129 12.8895 -2.74325 3.95657 -0.856162 +535 1 2.95855 8.84401 12.9769 -19.5266 -12.9618 -2.46154 +536 2 3.45638 9.64099 12.8192 4.11354 12.8609 -3.4499 +537 2 3.6113 8.17746 13.175 10.7686 -6.78904 5.39462 +538 1 3.18595 8.60313 3.78164 6.49512 -8.67182 57.5105 +539 2 3.58728 9.20701 3.1814 16.1034 15.9636 -13.6327 +540 2 3.51933 8.8716 4.70776 -18.429 -13.2453 -44.8458 +541 1 5.73851 7.25721 8.5964 -4.13987 -1.96532 11.6754 +542 2 5.69005 6.29369 8.53393 1.30439 2.87011 -1.70973 +543 2 5.04632 7.51192 9.22575 1.66035 -1.11756 -5.95213 +544 1 14.9081 1.62503 1.83745 -8.73365 -28.3512 -14.8102 +545 2 15.1675 2.29904 2.4498 2.46531 19.8996 4.15138 +546 2 15.1848 1.81402 0.924567 6.2551 4.83326 15.3454 +547 1 8.63912 15.0489 0.67096 1.85438 -3.84451 5.87273 +548 2 9.43742 14.948 1.21756 -6.6173 4.03251 -1.68679 +549 2 7.96284 14.4978 1.10066 2.22069 5.93818 -4.9944 +550 1 15.4364 1.44293 7.19944 -29.9197 -3.33934 -17.0244 +551 2 14.7125 0.994492 6.68707 24.0317 7.87524 16.0302 +552 2 15.0797 2.33705 7.33252 4.46076 -6.95989 4.74521 +553 1 4.93029 12.8913 18.4644 10.9792 1.21933 18.1223 +554 2 5.27563 12.987 0.740174 -6.01723 -1.47567 -19.726 +555 2 5.68015 13.1369 17.9044 -5.07302 3.16897 2.74711 +556 1 15.3923 8.68146 18.054 15.694 19.9465 -16.5309 +557 2 15.9315 9.21769 17.4147 -18.0717 -17.5644 15.7946 +558 2 15.1857 9.29971 0.121687 -1.56315 -2.75746 2.59172 +559 1 11.9784 3.14039 18.3403 11.1408 -7.29272 18.8649 +560 2 12.1001 2.9975 0.653392 -4.70819 -0.503108 -12.7749 +561 2 12.4778 2.40933 17.9385 -7.35096 7.48199 -3.86664 +562 1 13.1896 12.7267 5.18606 4.81883 -3.59528 0.0329893 +563 2 13.4958 11.8346 4.97314 2.3467 3.28367 -0.068752 +564 2 13.4618 12.8881 6.09814 -4.13789 -2.12194 -0.520265 +565 1 6.18108 7.13483 0.245639 -8.98659 -24.3205 -5.24363 +566 2 6.15368 8.0627 19.0493 5.02048 26.2765 -0.395042 +567 2 5.28324 6.84248 0.444666 1.40419 -2.69741 2.9636 +568 1 17.7469 15.8806 14.9091 -16.6307 4.82259 1.60218 +569 2 16.7811 16.0196 14.9781 16.1488 -1.66255 -6.01934 +570 2 17.9228 15.7652 13.9648 -0.217809 -0.705292 2.49903 +571 1 13.1074 0.925484 16.7107 3.18003 -6.63181 9.52558 +572 2 14.0398 0.701227 16.9047 -10.9319 3.14101 -7.94235 +573 2 12.6435 0.0729893 16.6565 6.11054 4.53406 -2.82687 +574 1 10.8779 14.5049 7.42771 23.1657 22.4115 -16.2389 +575 2 10.1426 13.9786 7.6854 -20.2069 -15.6201 11.4355 +576 2 11.6544 13.9411 7.50544 0.873985 -2.97227 1.69423 +577 1 17.7332 8.41688 2.16357 9.83329 25.3003 13.1733 +578 2 16.8474 8.49196 2.51389 -11.5025 -5.56634 1.51969 +579 2 17.684 7.86174 1.40275 -6.79002 -17.3841 -17.6814 +580 1 12.5241 7.78132 2.0423 -1.44154 17.0415 -14.1456 +581 2 12.3356 8.69211 1.74465 0.56853 -10.9135 10.1338 +582 2 12.0507 7.22418 1.41137 4.13261 -1.84431 -3.3422 +583 1 12.0402 14.5123 10.5082 -18.3289 -2.04433 -49.0296 +584 2 12.3885 14.3833 9.58045 -11.5085 2.39427 35.0464 +585 2 11.0712 14.6752 10.3612 24.5139 -2.29095 9.58119 +586 1 6.7433 6.75035 15.5111 8.69017 25.9379 21.8943 +587 2 7.64047 7.11596 15.2998 -22.3365 -16.355 4.27733 +588 2 6.42641 7.26782 16.2896 9.37622 -14.6905 -17.8302 +589 1 7.9604 4.42511 13.2728 28.7823 16.7879 24.018 +590 2 7.37747 4.63038 12.5661 -23.4436 4.48442 -18.6585 +591 2 8.25373 5.30295 13.5968 -1.99494 -17.578 -1.9241 +592 1 13.2943 12.2257 14.4027 3.56556 -5.33332 1.41443 +593 2 13.2861 11.2546 14.3815 -5.78887 6.10336 -0.82645 +594 2 13.6298 12.4878 13.5348 -0.194802 0.853385 3.24808 +595 1 14.4975 9.60743 7.32851 -1.81828 -22.5371 -11.9494 +596 2 15.283 10.0905 7.53237 20.8949 12.3364 4.94663 +597 2 13.7862 10.0745 7.73482 -16.3884 10.3496 13.6544 +598 1 12.6855 16.7955 3.35468 10.446 54.0378 -9.24021 +599 2 12.8247 17.4169 4.11373 -2.43161 -22.9959 -18.5255 +600 2 12.7287 17.4093 2.56008 -5.07923 -25.2307 27.5772 +601 1 0.985851 7.00227 17.3383 1.31889 9.4813 -6.51378 +602 2 0.174673 6.82729 17.8428 -2.72668 6.21708 -7.63644 +603 2 0.788987 7.63656 16.6124 1.43967 -10.9643 14.4702 +604 1 12.9703 4.85252 15.7444 36.7131 7.67865 -11.6648 +605 2 13.7444 4.28338 15.4912 -28.1266 12.6425 14.7219 +606 2 13.3848 5.73698 15.8318 -12.3641 -9.92719 -0.136909 +607 1 2.31739 3.41657 5.06312 -13.6796 12.8802 45.0615 +608 2 1.71742 3.03519 5.77756 22.5616 7.27981 -29.9715 +609 2 2.67638 4.25091 5.49055 -8.69432 -27.9074 -22.1065 +610 1 8.14626 10.9014 13.7501 23.1519 -21.2188 51.9658 +611 2 8.18961 10.6456 14.7569 -3.14293 16.1916 -66.8861 +612 2 8.91613 10.442 13.3487 -9.38929 12.2654 3.7561 +613 1 12.9965 1.57692 13.2293 -13.236 30.2614 -33.2276 +614 2 13.5053 1.61767 12.3799 -8.92772 -10.8244 27.0208 +615 2 12.3556 2.33631 13.1194 22.5086 -26.9187 11.5847 +616 1 6.63966 13.684 2.03193 -11.5531 1.65982 24.7971 +617 2 6.01437 14.0711 2.69678 13.9712 -7.1585 -19.9778 +618 2 7.21702 13.1132 2.57076 -4.92077 5.61769 -6.96253 +619 1 15.813 6.37449 12.4855 -26.0384 -19.2076 5.56376 +620 2 16.3133 6.94665 11.9354 17.458 16.492 -16.919 +621 2 16.1081 6.5465 13.3734 10.1637 1.50607 12.5345 +622 1 16.7517 0.683836 9.54032 9.17465 -17.8268 3.86543 +623 2 16.8312 18.3701 9.76674 -11.2714 16.7378 -3.92594 +624 2 16.3182 0.76443 8.67683 0.0107679 -1.03064 0.242674 +625 1 6.19528 11.6935 8.23629 -2.98771 -55.3704 13.0415 +626 2 5.39217 11.4329 8.74625 16.1659 14.5788 -12.0119 +627 2 6.59624 10.789 8.03203 -10.8651 41.6219 1.75135 +628 1 2.78257 8.63233 0.349942 -51.0927 -6.02203 -19.4773 +629 2 2.14734 8.16991 18.3384 31.254 20.3071 31.1367 +630 2 2.20011 9.24624 0.868363 16.6862 -13.9373 -14.0055 +631 1 10.0933 10.2699 6.60791 4.69659 2.91801 -6.95173 +632 2 10.6585 9.65933 7.0984 -2.33853 -1.64778 -0.152736 +633 2 10.478 10.3114 5.71024 -7.38541 0.394324 12.3102 +634 1 6.85971 15.7454 6.78123 4.24276 8.06212 3.90305 +635 2 7.14611 16.2575 7.56121 -6.95129 -7.98507 -8.49325 +636 2 7.04221 16.3283 6.02778 -2.00154 -5.2395 1.03704 +637 1 6.5672 12.9167 5.89107 0.597921 -4.77378 -3.41809 +638 2 6.75629 13.7931 6.22612 0.282518 9.70238 2.49815 +639 2 6.16516 12.4266 6.61937 1.75727 3.9196 -1.62353 +640 1 16.7395 12.5246 9.74847 -3.06854 -10.3396 -13.3378 +641 2 16.803 11.7934 9.09918 0.0574675 11.3505 13.7779 +642 2 17.2471 13.2388 9.35461 0.0307086 0.265441 4.69208 +643 1 6.27963 2.83254 2.76143 -4.73524 -28.0523 14.6006 +644 2 6.37898 3.73989 2.5277 5.16678 22.951 -10.7112 +645 2 5.79937 2.39077 2.0523 -0.657158 4.14199 -3.99187 +646 1 10.6834 2.9997 3.2493 -4.30343 6.66703 3.45031 +647 2 10.3389 3.87773 3.47337 -2.10815 -7.43082 -2.74741 +648 2 10.1644 2.67816 2.50044 1.52937 0.706493 -1.87803 +ITEM: TIMESTEP +100 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.77244 6.59569 17.9763 -3.45079 -15.6041 -9.13306 +2 2 7.88004 6.49722 18.3444 6.65526 3.83231 -3.73646 +3 2 8.88832 5.875 17.3232 0.339998 10.7344 11.2284 +4 1 0.232197 8.43163 6.74931 6.06809 -9.75314 40.4456 +5 2 0.255717 8.25928 5.82997 0.568886 -7.03857 -37.2819 +6 2 0.690537 7.6579 7.15764 -12.6716 20.3857 -3.7924 +7 1 8.73054 0.448274 6.96197 0.757688 5.19807 -2.99354 +8 2 9.64384 0.493158 6.62895 -11.5479 0.592924 -0.0248858 +9 2 8.1978 0.998025 6.35807 9.15448 -7.13553 5.61176 +10 1 6.40593 1.75267 11.8149 38.8296 -3.08614 -8.28972 +11 2 5.81968 2.38515 12.1727 -25.8813 19.5399 13.38 +12 2 5.91601 0.958217 11.6787 -14.9693 -21.4487 -5.83463 +13 1 6.93553 5.46707 2.3717 -29.4847 3.29264 10.9289 +14 2 6.2293 5.77948 3.0367 33.3819 -5.43232 -34.2308 +15 2 6.73101 5.82483 1.47662 0.276644 1.33511 28.97 +16 1 16.2706 10.1725 16.0328 16.576 -12.0275 -13.9735 +17 2 17.1689 10.3287 15.6909 -13.6837 1.56601 5.28727 +18 2 15.9002 11.0264 16.2303 -5.40144 13.1923 2.47446 +19 1 10.8573 14.9713 2.3127 -4.53536 -0.807355 -13.4682 +20 2 10.8458 14.5197 3.15612 -3.95698 -5.41896 6.20362 +21 2 11.2908 15.8056 2.48855 3.23834 4.77246 6.19277 +22 1 17.2232 8.21136 11.0033 2.73792 2.45641 -7.11401 +23 2 16.6726 8.88418 11.4331 2.86084 -2.93597 -0.581414 +24 2 17.9525 8.69866 10.5809 -6.6523 -2.55116 4.88578 +25 1 14.5937 16.0509 16.2923 16.8919 1.55785 -12.0612 +26 2 13.6919 16.3738 16.3176 -7.99874 0.738503 2.77307 +27 2 14.7362 15.4806 17.0483 -6.38665 -4.70858 10.3974 +28 1 12.1782 13.2488 0.556058 -6.41896 9.17153 -4.9038 +29 2 11.8393 13.4134 18.3136 3.64438 -6.73296 -6.87976 +30 2 11.6781 13.8768 1.08938 4.30308 -0.940018 9.70193 +31 1 9.32636 5.50189 3.85673 -23.6707 -6.9557 11.6523 +32 2 8.85207 5.35955 4.73387 10.6863 3.91607 -36.7024 +33 2 8.65492 5.41152 3.1282 11.356 3.18621 25.5004 +34 1 1.53424 3.89903 11.544 -4.66799 23.5976 14.1629 +35 2 1.33558 4.79151 11.9229 9.77101 -18.0042 -9.49869 +36 2 1.78943 3.33535 12.2834 2.68741 0.460061 1.88957 +37 1 2.11036 6.99869 8.11066 2.48315 -17.2899 2.96853 +38 2 2.57184 7.49315 8.78305 3.29023 12.1045 5.89357 +39 2 2.1177 6.10606 8.48449 -3.4025 -1.3508 -8.01694 +40 1 5.18347 4.46977 7.78792 -2.57538 4.03359 -5.12796 +41 2 5.37117 3.51932 7.65443 -4.82345 11.4027 -0.558597 +42 2 4.53495 4.79047 7.12216 11.4175 -13.4448 8.55636 +43 1 3.42716 2.88114 17.3924 1.12201 37.8538 -2.09818 +44 2 4.03218 3.21565 16.6954 -8.80258 -2.8612 13.6459 +45 2 2.96175 3.68375 17.7714 12.3959 -28.5801 -12.8282 +46 1 7.56049 5.45137 6.19682 -11.2764 11.7759 39.3451 +47 2 8.17338 6.02323 6.733 -17.9712 -15.9787 -15.2388 +48 2 6.83707 5.19934 6.84169 25.8687 -1.03041 -23.6459 +49 1 9.81873 7.03274 12.0818 18.6926 1.80354 21.1658 +50 2 10.1168 6.17447 11.801 2.37707 -8.57843 -5.75387 +51 2 9.13705 7.28384 11.4839 -21.9155 5.9942 -18.2818 +52 1 13.9782 3.81734 8.11005 -6.38125 -7.14222 -11.0636 +53 2 13.4268 4.53125 7.77431 4.97705 1.71109 -4.47031 +54 2 14.3288 4.12395 8.93436 6.50574 7.00298 17.9277 +55 1 4.54162 17.1358 3.87887 10.9044 35.7056 -0.341992 +56 2 5.36932 17.5648 4.19271 -11.2647 -17.0231 -6.60056 +57 2 4.14672 17.8103 3.27983 -0.0256371 -21.9717 9.98561 +58 1 16.2123 16.5489 10.6095 26.1835 -5.76397 -19.4616 +59 2 15.4589 16.7003 11.1416 -23.8325 7.35421 23.2226 +60 2 15.8886 15.8767 10.0022 2.98718 1.98497 -7.14015 +61 1 1.93449 4.79928 0.00082377 17.3961 -4.98991 5.57961 +62 2 2.67896 5.07161 0.592242 -22.0191 7.26131 -10.4701 +63 2 1.68005 5.53286 18.0583 5.78187 -2.17332 10.5029 +64 1 11.1761 13.3033 16.4476 20.6858 -29.5101 -20.5449 +65 2 10.7502 12.4348 16.5818 -0.505604 15.8506 2.04497 +66 2 11.8189 13.0874 15.7254 -14.483 14.0049 15.9552 +67 1 10.0082 10.9133 16.7377 -9.76065 -12.5647 6.43928 +68 2 10.4104 10.0696 17.0143 -3.0625 14.8211 -5.5238 +69 2 9.04798 10.758 16.6751 14.6534 4.77532 0.819581 +70 1 11.8926 17.5507 13.5059 -15.5524 -14.4544 -0.25773 +71 2 12.4585 17.1847 12.8152 4.41482 5.53476 3.60851 +72 2 11.9755 18.5016 13.5139 9.00416 11.9454 -7.12981 +73 1 6.39659 9.54323 12.3526 -12.6063 6.46711 4.93213 +74 2 6.97402 9.29797 11.635 9.25294 -5.21247 -6.5221 +75 2 6.9248 10.0607 12.9773 -1.49192 -5.83682 -8.37915 +76 1 16.2827 12.8664 2.8283 0.430065 -24.2056 0.300325 +77 2 17.1271 13.2094 2.55074 10.9303 3.80489 0.0707423 +78 2 15.7284 13.6342 2.87288 -15.0446 12.1841 2.12753 +79 1 0.782434 12.8185 5.85612 -33.4557 3.27495 -26.778 +80 2 1.12737 12.9122 4.94214 -3.16706 -8.15793 13.9432 +81 2 18.4302 12.7528 5.74133 33.3816 -1.67566 5.80796 +82 1 5.29416 16.3645 18.462 -0.365113 -1.85929 1.37874 +83 2 5.65117 15.5929 17.9841 -1.41418 12.24 9.00358 +84 2 5.90904 16.5787 0.535619 -2.78951 -3.81837 -4.76209 +85 1 0.717617 7.68269 4.16298 45.78 12.5398 -25.9452 +86 2 0.140595 7.95484 3.42088 10.68 -3.85526 14.32 +87 2 1.67421 7.98176 3.89702 -61.12 -15.169 17.2669 +88 1 3.20538 9.16537 6.53153 -16.7997 -26.3462 11.633 +89 2 3.63886 8.66012 7.25517 -10.7634 14.1338 -16.8685 +90 2 2.28456 8.785 6.4428 29.8979 17.6904 5.8263 +91 1 7.3492 10.4558 16.1821 -32.1717 -5.51262 30.2531 +92 2 6.6595 11.1272 16.0448 13.9154 -6.26319 -1.99334 +93 2 7.03952 9.99344 16.9918 7.69449 10.9592 -10.5833 +94 1 10.9926 0.857119 5.02234 -5.32556 5.69944 -21.4369 +95 2 11.0071 1.72344 4.58448 5.20867 -2.07691 11.6276 +96 2 10.6449 0.320945 4.28448 4.96755 -3.65716 14.4683 +97 1 4.17972 2.99732 13.1563 8.08367 -30.8511 5.02994 +98 2 4.53886 3.3528 13.9956 -8.94088 -10.2248 -10.148 +99 2 4.12323 1.98418 13.2207 2.50903 42.0947 6.54014 +100 1 8.52337 10.2728 1.80778 10.3789 -10.908 24.8689 +101 2 8.43412 10.9106 2.54849 -2.4679 -8.46295 -11.8092 +102 2 8.72683 9.4118 2.24878 -4.48166 20.4458 -7.62428 +103 1 10.3146 1.66303 15.4651 0.0280032 6.46587 3.16016 +104 2 11.2365 1.5769 15.7049 7.71736 -2.87845 -0.628854 +105 2 10.2832 2.03916 14.5766 -0.873711 -2.30994 -1.44208 +106 1 2.60872 12.9688 7.93078 -1.0685 2.90827 1.70102 +107 2 3.08524 13.7852 7.70925 1.81136 -8.54773 -5.41906 +108 2 2.07592 12.7429 7.1537 2.1601 3.22826 4.8584 +109 1 3.84139 11.714 4.98357 -9.2182 -6.48315 2.00023 +110 2 3.59649 11.1336 5.73363 3.13206 7.92599 -15.0555 +111 2 3.08391 11.75 4.36582 7.48234 -0.753218 11.1676 +112 1 6.65636 14.539 16.9808 1.14971 -3.74934 -0.345026 +113 2 7.45699 15.0461 17.1534 0.734042 -3.82079 -1.22553 +114 2 6.35462 14.7758 16.0963 4.10604 -0.420587 -1.60546 +115 1 14.2186 14.4753 3.18712 8.31434 -1.03143 -11.3814 +116 2 13.7635 15.2982 3.34662 -3.59872 10.6386 -1.06184 +117 2 13.8465 13.8568 3.80574 -6.38377 -9.35153 11.7656 +118 1 8.76639 18.036 16.1575 -17.2352 -7.71273 4.18589 +119 2 9.29865 17.253 16.446 -1.99578 26.3863 -16.3924 +120 2 9.21082 0.13577 15.7005 10.7734 -16.3176 12.3305 +121 1 4.70057 1.84937 4.90583 -5.59427 22.8387 -36.2464 +122 2 3.793 2.25175 4.86575 28.8401 -10.2604 4.23254 +123 2 5.1801 2.18711 4.08016 -18.9233 -12.3263 38.2061 +124 1 15.0501 12.6021 16.5687 -12.0311 0.26828 5.88874 +125 2 14.6786 12.8761 17.4109 9.53333 3.55003 6.01908 +126 2 14.2645 12.5148 16.0221 4.98358 -1.43573 -15.5641 +127 1 15.7004 18.5129 16.8573 39.713 -3.42746 23.3516 +128 2 16.4681 18.7143 17.5055 -38.5977 -15.0096 -30.817 +129 2 15.6109 17.5396 16.7903 -2.54574 14.9499 6.02131 +130 1 1.36802 1.35817 16.6529 -7.19601 7.74866 13.6684 +131 2 2.15913 1.86948 16.876 -3.57304 -8.28302 -6.01627 +132 2 0.751389 1.61649 17.3659 4.93092 -7.13328 -12.7379 +133 1 18.2443 4.33431 15.8699 4.87602 -2.4936 -15.9817 +134 2 17.8369 3.63124 15.3424 2.32992 6.4949 4.25729 +135 2 0.452078 4.51482 15.4394 -9.42811 -2.49011 8.2103 +136 1 12.0529 17.1173 16.1421 -28.5646 -13.5401 15.8604 +137 2 11.3287 16.6705 16.6559 24.6179 11.2855 -13.6919 +138 2 11.708 17.1501 15.239 10.7504 0.848438 1.34073 +139 1 16.0751 2.69533 18.2299 -16.8426 22.7601 -19.9608 +140 2 15.7518 3.52741 18.6545 8.16925 -19.768 -14.2608 +141 2 15.768 2.75869 17.2894 6.47211 -5.43997 24.4047 +142 1 6.70105 13.7211 10.0493 -2.92253 -3.29615 13.924 +143 2 6.49616 13.3451 10.9223 2.46715 2.87816 -3.90822 +144 2 6.5701 13.0016 9.42848 5.58743 -2.71244 -4.10916 +145 1 10.1642 18.4563 2.66846 -6.4553 9.35236 -16.0973 +146 2 10.4494 0.522706 2.05557 -0.598662 -14.7868 7.93587 +147 2 9.23943 18.2921 2.43567 5.35466 0.524311 4.08806 +148 1 3.08905 17.6286 6.23363 28.1073 -1.15148 23.9606 +149 2 2.19758 17.5876 5.91536 -10.6529 4.22104 -18.8026 +150 2 3.7136 17.7221 5.50184 -12.297 -3.14114 -7.6924 +151 1 12.6187 16.7784 7.83399 -8.24743 2.38577 1.37984 +152 2 11.9273 16.0794 7.74003 7.37944 21.7069 5.85683 +153 2 12.3535 17.4638 8.48865 -0.622135 -17.7991 -6.24189 +154 1 14.8741 15.2807 8.33754 11.6667 3.93031 -5.87838 +155 2 14.2607 15.9458 8.0029 -4.6938 -2.09697 8.01324 +156 2 15.5465 15.2244 7.63778 -8.32879 0.363275 5.25782 +157 1 17.8358 18.3077 0.207666 -46.6557 3.82667 -12.4063 +158 2 18.5381 17.6928 0.20107 34.3258 -19.0599 -1.41311 +159 2 18.1099 0.429917 0.68066 12.6369 19.0779 11.4558 +160 1 0.768971 10.519 1.45234 -14.3967 -19.3664 19.1268 +161 2 -0.0407552 10.0454 1.78172 23.5075 9.70284 -14.2764 +162 2 0.503185 11.1892 0.827858 -7.10365 8.12718 -9.46819 +163 1 1.82037 12.3064 3.2607 -0.411525 2.12628 17.6018 +164 2 1.36119 11.682 2.70611 -2.67447 -10.2614 -7.1426 +165 2 2.03731 13.0482 2.69872 0.079619 5.20365 -3.96737 +166 1 0.725717 17.3003 4.98992 32.4002 3.58468 -34.9181 +167 2 -0.000639544 17.8885 5.08952 -19.7566 14.3988 12.6832 +168 2 0.713313 16.5777 5.58791 -15.4184 -21.9192 25.4801 +169 1 0.951486 0.797441 9.37101 14.826 11.188 -16.0996 +170 2 1.14791 0.588384 10.2838 -3.41112 -8.44303 11.2353 +171 2 0.0745467 0.497625 9.13864 -8.88294 -4.64793 9.22513 +172 1 16.8073 2.38946 13.4769 5.39787 -10.4284 -8.99471 +173 2 17.0506 2.69304 12.5747 -8.0967 -7.05722 13.8788 +174 2 16.5161 1.45381 13.4188 4.66162 13.0486 -2.08534 +175 1 2.62912 16.0502 12.0784 8.40953 -12.472 -10.7904 +176 2 3.04385 15.7269 12.8881 -2.37218 0.184289 -5.79457 +177 2 3.10949 15.6337 11.3228 -8.7582 6.42497 16.6586 +178 1 16.3457 15.4302 6.12389 30.9011 24.8554 -18.1041 +179 2 17.2992 15.5349 6.36757 -22.0844 -7.23183 -0.993592 +180 2 16.19 16.1865 5.50068 -1.85714 -20.6143 14.9819 +181 1 5.77873 5.21745 11.785 11.0193 -20.9315 -11.6683 +182 2 5.50793 5.92484 12.3546 -4.36629 16.5013 7.19057 +183 2 5.27867 4.45162 12.0794 -6.37659 -1.59945 -1.70387 +184 1 15.1747 4.94504 0.761547 -29.5175 -4.13494 28.6724 +185 2 14.9952 4.57194 1.67189 6.69018 16.901 -24.5633 +186 2 14.3176 5.30548 0.449447 18.0211 -8.94221 4.63226 +187 1 16.4144 16.461 1.77501 8.34865 -5.69196 -8.65308 +188 2 16.356 16.7636 2.67626 -8.71628 3.92983 13.8981 +189 2 16.7832 17.2073 1.29403 -0.614878 1.7319 -3.63708 +190 1 0.136057 4.8659 3.98965 34.6037 22.2365 -2.60366 +191 2 0.554963 5.79058 3.9624 -19.788 -38.6093 6.27627 +192 2 0.840291 4.21253 4.20207 -10.6708 20.7839 -4.14843 +193 1 2.91044 15.0804 15.1041 7.34684 -10.5058 14.2682 +194 2 2.90482 14.7198 16.034 -7.41786 16.0657 -24.8201 +195 2 2.46761 15.9418 15.099 -2.49045 -2.68752 9.6724 +196 1 0.98952 14.6361 9.40184 3.41519 -3.90395 6.55514 +197 2 1.54705 13.945 9.00075 -6.08548 3.23571 10.1521 +198 2 0.78947 14.3674 10.3125 0.535168 -4.82993 -11.1122 +199 1 13.5676 16.5089 11.5672 -19.673 9.58551 -20.9583 +200 2 13.2883 17.2623 10.9814 5.35041 -18.2182 15.9177 +201 2 13.0352 15.7491 11.2513 9.15027 7.77217 2.32965 +202 1 4.84709 1.60354 0.665871 -13.2454 -7.94988 -14.2061 +203 2 4.37724 2.10746 -0.0295305 4.1335 -5.07179 15.4313 +204 2 4.23428 0.890311 0.93575 7.29231 10.3056 3.49355 +205 1 1.57562 18.6232 11.9448 -9.54215 3.4719 -19.1533 +206 2 1.53947 0.452662 12.7669 0.622104 8.67092 13.3018 +207 2 1.94164 17.7639 12.1401 7.67295 -5.68018 1.31967 +208 1 11.3828 10.0809 4.23132 25.5406 -0.783734 -33.5194 +209 2 11.2477 10.3841 3.29047 7.40472 -5.62792 30.1478 +210 2 12.3604 9.90108 4.31318 -36.068 9.82931 1.34024 +211 1 8.1924 12.225 3.79726 -5.69748 14.5101 56.1678 +212 2 9.05523 12.5573 4.13122 -12.2475 -6.42112 -18.1901 +213 2 7.61811 12.3317 4.63279 18.664 -10.6547 -44.172 +214 1 14.6446 4.04033 3.3856 3.29585 4.20735 14.8065 +215 2 15.1799 4.13354 4.21231 -10.8641 -1.34483 -21.0767 +216 2 13.7289 4.27483 3.60977 8.83721 -0.102893 1.13309 +217 1 5.73789 1.70847 7.633 -45.2268 -33.2589 19.0394 +218 2 5.00558 1.12579 8.07813 40.2552 34.7696 -21.6936 +219 2 5.52319 1.67762 6.69069 2.06189 0.609235 -2.30714 +220 1 17.8554 0.94247 4.83325 2.84508 1.94772 -6.32822 +221 2 18.4375 1.13729 4.06994 -6.68522 3.20321 14.3473 +222 2 17.8361 1.70281 5.4359 2.52705 -5.98387 -7.60558 +223 1 6.82607 9.13014 4.53731 -2.03949 -2.27606 -0.824268 +224 2 6.749 9.37751 5.45829 -4.27203 4.05265 7.19029 +225 2 7.76352 8.95198 4.44117 4.86868 -1.78157 -6.05796 +226 1 2.39805 14.6397 2.05874 17.0918 -1.49078 4.46086 +227 2 3.17145 14.6314 2.66377 -10.8679 0.525641 -12.6634 +228 2 2.72903 14.4183 1.17543 -1.81421 4.03234 5.90777 +229 1 17.1796 12.9575 13.0281 -10.0626 2.91445 0.0973403 +230 2 16.3048 13.3397 13.2675 20.7192 2.62525 -4.36947 +231 2 17.7682 13.6617 12.6978 -15.1419 2.46765 5.43564 +232 1 14.7925 10.5715 1.51204 -8.6843 -36.4521 -19.1925 +233 2 15.3686 11.2103 1.85793 27.186 33.4644 17.5702 +234 2 13.9217 10.9161 1.62765 -18.2001 7.18743 0.677482 +235 1 5.63756 6.65584 4.53835 -5.70194 -14.7917 8.95129 +236 2 5.96892 7.55557 4.50237 4.06113 5.5935 -1.33512 +237 2 6.19689 6.19506 5.18786 2.48768 6.43185 -8.34619 +238 1 8.1035 8.32015 10.3633 -6.06951 -1.51391 13.5103 +239 2 8.71051 8.88696 9.88772 3.75134 6.39998 -5.242 +240 2 7.4427 8.01108 9.7382 -0.891776 -1.59521 -4.95879 +241 1 13.4554 18.4382 5.64567 -23.0826 -2.6609 26.3697 +242 2 12.6541 0.350227 5.51512 12.1971 -9.37205 -2.29397 +243 2 13.2308 17.8847 6.43702 5.12544 9.06169 -21.995 +244 1 0.0481459 2.53289 0.450073 0.762545 20.3906 -8.36614 +245 2 17.7393 2.57826 18.829 23.3906 9.65711 1.86789 +246 2 0.50996 3.41343 0.303855 -21.6669 -27.8541 1.68488 +247 1 12.9745 10.8048 9.65469 -32.5048 41.5261 -13.285 +248 2 12.0083 11.0976 9.65119 33.8953 -25.1931 3.11551 +249 2 13.0333 9.87229 9.85209 -8.8072 -6.07099 4.09073 +250 1 0.527116 12.3319 11.2575 10.4347 -0.622496 2.4881 +251 2 18.2313 12.2915 11.4294 -10.2968 -1.46033 -6.74513 +252 2 0.909084 12.5363 12.117 7.12796 0.366826 -3.41572 +253 1 5.28415 7.34725 13.2845 -6.32664 2.65038 2.55184 +254 2 5.64713 8.17412 12.9655 4.82658 4.12789 -9.57053 +255 2 5.74627 7.2293 14.1116 0.316635 -7.58532 9.69513 +256 1 1.16454 6.74183 12.03 -13.1625 -42.3004 -9.02199 +257 2 0.295417 6.98712 11.7254 -9.09418 5.46945 -3.0829 +258 2 1.57891 7.53521 12.2772 19.8541 36.5775 12.6901 +259 1 15.5783 9.75012 12.4577 9.71681 16.8235 16.5595 +260 2 15.2431 10.6351 12.2158 0.950441 -15.6258 3.07953 +261 2 16.0853 9.89705 13.2804 -12.0519 -4.92211 -13.1427 +262 1 16.5993 12.6285 5.60521 -10.2494 37.6021 -45.7262 +263 2 16.4242 13.6113 5.62967 5.67224 -29.3823 14.3376 +264 2 16.441 12.4706 4.63081 7.92181 -5.25591 31.2114 +265 1 6.41284 9.90681 0.119653 0.515871 -10.7086 -9.9123 +266 2 5.64934 10.3727 0.465056 -3.06655 2.33505 3.46562 +267 2 7.14462 10.1266 0.702846 2.16363 1.41956 4.36049 +268 1 12.2095 5.93838 4.00309 -11.5544 -2.90268 -3.08172 +269 2 12.2942 6.66752 3.37735 2.08742 0.382808 1.33145 +270 2 11.2587 5.74648 4.01779 6.74513 0.670066 1.17813 +271 1 0.342924 12.9268 0.00967172 -2.71894 -2.13654 5.95194 +272 2 18.7348 13.4393 0.793746 3.88983 0.588143 -5.53597 +273 2 18.4589 13.2921 17.9296 1.41778 -5.28425 5.34754 +274 1 3.57599 18.7244 8.67011 -7.57313 7.8026 -17.3863 +275 2 3.53053 18.3214 7.79351 4.94999 -5.98969 2.51912 +276 2 2.6975 0.472694 8.72681 1.72246 -0.921876 11.7862 +277 1 7.19816 17.4543 4.42938 13.0422 27.6578 -13.842 +278 2 7.51541 18.3714 4.6455 -6.70989 -26.1973 -6.43912 +279 2 7.34255 17.3635 3.4592 -3.95356 0.0926602 20.0901 +280 1 9.24276 17.181 12.1874 27.1924 -9.91753 -12.8104 +281 2 9.16544 16.536 11.4403 4.06483 10.4089 22.9332 +282 2 10.1989 17.1789 12.4847 -33.3611 -0.423317 -5.22003 +283 1 13.2427 13.2324 7.99028 -4.63127 -11.2433 10.7708 +284 2 13.2975 12.5097 8.63573 0.309708 1.2863 -7.28868 +285 2 13.9184 13.8596 8.25103 7.01778 4.96536 -0.211076 +286 1 14.7706 2.86972 15.5058 12.3246 -20.976 -18.3849 +287 2 14.0341 2.28041 15.2496 10.8751 5.18171 6.07562 +288 2 15.4548 2.72916 14.8136 -15.3015 9.06101 10.4071 +289 1 9.96013 15.6554 16.9624 -0.416257 -4.3558 -3.6035 +290 2 10.3061 14.8055 16.6414 -1.75696 6.53817 2.71112 +291 2 9.61308 15.4752 17.8389 -3.07369 -3.40172 1.73448 +292 1 11.2206 8.54091 16.6271 11.2119 0.246209 -0.153837 +293 2 10.3853 8.13843 16.425 -12.7378 -7.75768 -8.20822 +294 2 11.7159 7.85532 17.0695 3.92811 -4.5145 7.83184 +295 1 4.19128 18.3534 16.7936 -2.0541 -15.6573 2.75359 +296 2 4.49896 17.6946 17.4386 1.3239 2.14246 -6.87061 +297 2 4.3476 0.553135 17.2025 -0.294224 9.43754 2.6314 +298 1 2.38271 4.321 8.90759 20.0465 -16.3105 29.2362 +299 2 3.33364 4.03277 8.87737 -27.5446 13.4253 -3.78204 +300 2 2.08958 4.1083 9.83354 7.71669 6.29647 -26.7475 +301 1 9.9842 10.4369 9.88352 -17.0195 21.6351 -0.0387615 +302 2 9.44133 11.1731 9.47934 17.4922 -21.0458 18.4718 +303 2 9.94225 10.4854 10.8652 2.27572 1.94662 -18.6097 +304 1 9.85899 0.920399 10.8075 0.162278 -2.63975 1.09763 +305 2 9.48302 0.0750215 11.0855 -2.58178 2.3482 3.77053 +306 2 9.21377 1.33985 10.2254 -0.0206645 -1.54215 -2.59695 +307 1 9.16055 15.229 10.2075 -19.4407 -6.65372 -14.862 +308 2 8.92137 15.8821 9.51239 -0.317996 -13.1788 14.0466 +309 2 8.43697 14.5477 10.1944 18.1534 21.6077 -0.815821 +310 1 0.71674 9.75329 10.1461 2.10813 23.2969 8.50765 +311 2 0.819344 10.7283 10.3167 -3.94998 -28.3852 -4.44668 +312 2 1.15296 9.53542 9.32246 0.728257 4.55427 -3.87479 +313 1 17.2456 4.88922 8.01698 -15.6269 -0.477795 25.7007 +314 2 16.4423 5.19943 8.52213 28.7194 -9.29348 -15.89 +315 2 17.7804 4.31587 8.60398 -15.5446 9.64156 -7.98894 +316 1 14.822 14.6129 0.044879 1.26259 -7.26488 27.1569 +317 2 15.5503 14.8635 0.654609 -16.5042 1.70925 -13.2775 +318 2 14.1019 14.3181 0.644441 11.2495 5.19015 -13.4399 +319 1 3.93398 11.151 9.56657 -13.0999 1.1143 6.92396 +320 2 3.8819 11.1389 10.5379 -0.108421 8.58768 -6.25849 +321 2 3.2885 11.8101 9.24754 8.95434 -7.44407 0.420275 +322 1 11.481 10.7372 1.49136 -12.2308 11.5287 -6.19882 +323 2 11.6479 11.6347 1.11375 -3.03535 -20.3842 8.82813 +324 2 10.5208 10.5745 1.38561 13.1816 3.92224 -1.496 +325 1 13.1382 7.21836 12.5396 -14.3564 7.08975 0.177427 +326 2 14.0771 7.12045 12.4061 13.875 -7.92794 3.07029 +327 2 12.7619 6.3345 12.5945 1.25366 -4.42296 3.81153 +328 1 9.68698 1.99848 0.824055 10.3256 0.727137 24.2023 +329 2 8.81917 1.78721 0.50968 -15.0497 -1.62599 -5.65 +330 2 10.155 2.38703 0.0980655 8.32187 5.69202 -13.7925 +331 1 10.602 13.3929 4.55586 17.4753 0.473987 25.0493 +332 2 11.4671 12.9458 4.66597 -13.9744 4.33191 -5.6004 +333 2 10.4831 13.8198 5.42698 -1.33045 -1.26907 -13.5894 +334 1 14.5505 1.55995 10.9504 0.793491 3.39408 -6.18689 +335 2 15.3506 1.17936 10.5364 -11.0229 12.1378 4.59402 +336 2 14.5582 2.53024 10.8225 7.4254 -12.0179 1.55597 +337 1 14.4508 12.0407 11.6074 10.4267 -5.99888 -36.1251 +338 2 15.2905 12.2256 11.0848 -31.5625 -1.98982 15.431 +339 2 13.8033 11.6041 10.9773 26.0423 16.8772 21.3357 +340 1 8.16091 5.15464 9.81808 -31.1733 -3.04727 19.1057 +341 2 7.28259 5.21015 10.2725 23.9466 4.77499 -10.0641 +342 2 8.23945 4.21356 9.63446 4.25293 -1.90524 -4.29988 +343 1 1.57078 16.9857 18.5145 2.11582 4.65495 -1.34384 +344 2 1.81738 17.3492 17.6562 0.32294 -2.46744 1.69741 +345 2 1.87051 16.0745 18.5076 0.982883 -4.60963 -1.80737 +346 1 1.40224 17.4231 15.3612 30.835 -28.8708 -16.9337 +347 2 1.58171 18.2262 15.8024 1.01568 35.607 16.5514 +348 2 0.474852 17.284 15.3634 -28.8421 -6.17683 0.802216 +349 1 3.44554 5.70547 6.04619 4.62282 22.475 -0.524537 +350 2 3.1428 6.44974 6.61309 0.90031 -17.6364 -10.4242 +351 2 4.06586 6.09018 5.39907 -5.11167 -0.757253 7.03456 +352 1 12.635 9.5385 14.2471 10.4135 -57.691 -2.75625 +353 2 13.0561 8.75521 13.7543 -17.7171 41.3381 15.7803 +354 2 12.3533 9.10151 15.082 0.88858 17.3566 -13.7461 +355 1 4.11217 15.1814 7.19429 24.0597 14.9458 -6.20919 +356 2 3.65166 15.9525 6.80506 8.00815 -8.18076 7.53786 +357 2 5.09537 15.3539 7.08579 -34.9804 -3.92885 1.78443 +358 1 0.830872 8.84313 15.1657 1.50937 4.0339 -6.81168 +359 2 0.547306 9.77972 15.0966 9.11455 -14.6477 -1.64448 +360 2 1.6109 8.72602 14.589 -11.0561 6.95599 3.23137 +361 1 12.8981 8.26079 10.0923 10.5692 -21.7103 -4.02448 +362 2 13.6229 7.70102 9.77244 -0.136865 10.7899 -7.02632 +363 2 12.7945 7.93077 10.9815 -6.52785 3.68747 11.7154 +364 1 15.1981 8.09018 3.38532 -13.0459 -52.6521 2.11346 +365 2 14.5247 7.61376 2.86907 3.36606 26.685 -8.7616 +366 2 15.3386 7.39586 4.05885 15.5852 26.7124 4.01456 +367 1 17.1365 6.7605 0.0284285 -19.4133 2.32297 -2.08842 +368 2 16.6422 5.96523 0.300426 11.1165 9.80228 -2.81184 +369 2 16.4267 7.37993 18.3943 16.5678 -7.00446 5.84521 +370 1 8.97527 7.00353 7.90402 -12.8517 -1.3564 7.9131 +371 2 9.8962 7.25242 7.83012 8.98921 2.98997 4.36252 +372 2 8.82463 6.62979 8.79874 5.5237 0.780274 -18.1173 +373 1 12.5342 0.599732 1.22272 7.37234 -11.2249 5.10795 +374 2 13.3221 0.863275 1.71742 -3.27048 6.46822 -3.34517 +375 2 12.885 0.18837 0.429335 -4.8121 3.35952 -2.50919 +376 1 5.70486 15.0289 14.4325 -10.0966 26.0987 -8.04315 +377 2 4.75654 15.1126 14.6498 8.83064 -2.51751 -1.0487 +378 2 5.99172 15.9344 14.1552 -2.67099 -19.6319 8.34541 +379 1 3.68772 6.51886 1.67786 -9.02664 17.532 -4.1283 +380 2 3.3123 7.35563 1.32777 6.95322 -18.4916 -0.718273 +381 2 3.69933 6.70385 2.62114 4.49099 -5.2411 1.79351 +382 1 3.84119 11.2683 12.301 -11.0219 1.87445 3.30422 +383 2 4.7083 11.6207 12.5295 0.62865 1.71432 1.43021 +384 2 3.16952 11.829 12.7259 9.18863 0.324364 -2.3982 +385 1 5.33774 3.90131 15.6575 3.88008 58.1131 -0.302695 +386 2 6.0029 3.30263 15.356 18.6017 -19.7261 -0.90724 +387 2 5.77609 4.81808 15.6348 -20.8077 -39.2998 1.51453 +388 1 13.9476 10.0954 4.76119 43.1598 -13.631 -14.8551 +389 2 14.3099 9.89525 5.64952 -11.5358 -2.78357 -16.2598 +390 2 14.5437 9.62633 4.09138 -26.3956 16.5702 30.5617 +391 1 7.47949 17.2779 8.9575 1.27559 12.2273 10.3752 +392 2 6.80648 17.541 9.63427 13.3482 -0.885269 -20.4433 +393 2 7.81637 18.0666 8.4826 -8.0179 -7.75644 7.92076 +394 1 4.60365 14.3557 3.73459 -2.67085 -0.0597314 40.4087 +395 2 4.53549 15.2621 4.14744 4.43815 -28.6634 -11.7113 +396 2 4.62044 13.6529 4.46513 -1.80956 31.3212 -27.6241 +397 1 14.2431 7.29194 15.9057 25.6353 16.9765 2.1683 +398 2 15.0475 7.32515 15.3368 -17.0197 -3.00413 14.2387 +399 2 14.4656 7.87429 16.6673 -6.53416 -15.6271 -13.0076 +400 1 2.96496 18.4208 1.99119 15.7852 32.1682 20.7835 +401 2 2.67672 17.8955 1.28044 -15.5564 -27.5435 -28.9446 +402 2 2.23493 0.385121 2.17733 5.2916 -3.96739 2.45348 +403 1 7.98476 1.5873 4.50407 1.38949 2.52923 0.695279 +404 2 7.37343 2.0449 3.91068 5.19751 -1.80104 2.00097 +405 2 8.86519 1.9238 4.29038 -5.22298 -3.29695 -0.501883 +406 1 2.57117 14.1691 17.7571 1.007 -17.2424 4.53378 +407 2 1.90219 13.4698 17.9606 14.5878 19.4169 -2.4542 +408 2 3.44824 13.7555 17.8862 -10.6426 1.83574 2.42644 +409 1 1.00451 2.03285 13.8784 10.3502 2.39599 -10.3714 +410 2 1.16144 1.84563 14.7992 2.97823 -2.88805 14.0985 +411 2 0.0700994 1.90667 13.7535 -13.5508 1.82952 -2.05389 +412 1 4.33902 0.200757 13.8843 13.0721 -10.005 -1.30306 +413 2 5.22858 18.4296 13.858 -15.0619 9.43809 1.75921 +414 2 3.93054 18.5168 14.6942 4.28146 4.19272 1.73225 +415 1 7.39543 1.05973 18.4904 -6.66444 -3.84456 4.72925 +416 2 7.66739 0.634389 17.6825 2.48525 -3.87431 -15.5197 +417 2 6.44311 1.20989 18.4324 3.08246 -0.882049 5.31666 +418 1 15.7652 18.4035 13.928 -3.86344 6.1861 11.5309 +419 2 14.8535 18.6979 13.7607 9.26883 -6.83338 6.65234 +420 2 15.8985 -0.310566 14.8997 -7.7909 7.80446 -17.2978 +421 1 10.2952 4.64795 16.1844 -42.7729 -17.7833 -2.18791 +422 2 11.2045 4.84382 16.2798 37.5776 1.06228 1.58962 +423 2 10.2217 3.67206 16.1998 1.46017 15.0252 -2.22652 +424 1 15.8927 17.6472 4.46477 -15.4234 23.5431 17.5975 +425 2 16.4754 18.4255 4.65687 -16.3789 -18.5079 -6.3799 +426 2 14.9773 17.9018 4.78742 33.6258 -6.52099 -13.8394 +427 1 6.90155 17.6195 13.966 46.0362 -18.082 7.69792 +428 2 7.5054 17.5909 14.7751 -24.8486 6.04139 -28.3759 +429 2 7.50943 17.3755 13.214 -16.8133 11.713 21.5591 +430 1 13.2082 6.37265 6.52765 -13.548 -6.29238 7.5029 +431 2 14.0171 6.83631 6.34759 17.8515 4.0742 0.884882 +432 2 12.7912 6.26458 5.66961 -1.80962 -1.49443 -3.94736 +433 1 7.85263 2.26509 9.52735 -7.99894 -5.84405 -22.7054 +434 2 7.25184 2.06178 10.2504 -3.996 2.15095 3.09306 +435 2 7.39499 1.97805 8.69805 10.2818 7.88442 20.3126 +436 1 15.1135 14.8377 13.7906 -14.0873 7.85215 4.54273 +437 2 14.8065 15.1503 14.6696 4.89633 -5.66092 -15.9193 +438 2 14.526 15.2486 13.1323 8.68819 -2.70507 8.56313 +439 1 9.34389 8.42481 3.82801 17.2784 -12.6228 -3.36469 +440 2 10.2481 8.71643 4.0808 -19.781 -0.493733 -4.13474 +441 2 9.39514 7.45876 3.71283 -1.01674 10.6173 4.41109 +442 1 17.6406 13.5721 16.5094 2.04355 14.6677 -13.2606 +443 2 16.6957 13.3564 16.5004 3.03121 5.86868 -4.35941 +444 2 17.7908 14.3862 15.9732 -9.46726 -16.3028 8.56732 +445 1 4.98477 10.3524 2.78056 12.7386 5.36526 19.5004 +446 2 5.77841 9.87677 3.08402 -8.11584 2.70387 -5.95057 +447 2 4.78102 10.9105 3.55814 -3.18863 -4.34789 -14.1468 +448 1 3.61985 8.409 9.90418 -6.90754 6.83907 7.996 +449 2 3.65115 9.35813 9.71914 3.08439 -3.40065 -3.71786 +450 2 3.2182 8.36489 10.7858 3.70965 -2.47637 -5.74153 +451 1 15.9601 6.9243 5.80742 5.84252 7.06727 3.15212 +452 2 16.6786 7.33659 6.3256 -10.6597 -9.43019 -8.8571 +453 2 16.2068 5.99858 5.66915 1.21675 5.97088 2.68601 +454 1 15.2845 7.30815 8.96614 12.789 49.367 -12.5087 +455 2 15.9618 7.62249 9.60336 -10.429 -10.3168 -7.48119 +456 2 15.189 8.09577 8.33246 -3.07462 -40.144 23.8491 +457 1 6.1828 12.7537 12.7561 7.28509 13.2747 4.63662 +458 2 7.05451 12.4627 13.0861 -13.4204 -0.208789 -0.140696 +459 2 5.95622 13.5898 13.2147 8.13015 -13.1574 -2.88232 +460 1 12.1263 4.55994 13.1396 29.7192 24.8274 2.05513 +461 2 12.1786 4.68706 14.0984 -0.0287765 -3.56256 -2.83377 +462 2 11.367 4.05454 12.9285 -29.3831 -17.3036 -0.987503 +463 1 11.4694 8.07241 7.80966 2.82892 -5.30182 3.11258 +464 2 12.1089 7.42736 7.43222 -7.16455 14.3649 9.80055 +465 2 11.7078 8.26067 8.74179 3.19872 -8.99269 -16.594 +466 1 16.9463 10.7531 7.60486 21.0922 -19.3927 -30.7185 +467 2 17.5464 10.0071 7.31859 -16.0594 21.8542 15.0855 +468 2 16.9098 11.3402 6.82058 -3.06841 -4.58473 14.7168 +469 1 5.28146 18.0409 10.6472 -25.9515 -7.83546 -6.26387 +470 2 4.85268 17.2439 11.0337 11.609 18.382 -10.1496 +471 2 4.62194 18.3715 9.98111 20.3861 -11.8767 18.8687 +472 1 7.65293 17.466 1.56177 -3.43219 -2.17163 16.4468 +473 2 8.27069 16.8213 1.23778 3.23069 -17.6415 -5.16563 +474 2 7.58305 18.0963 0.859771 -3.72786 20.9018 -9.77855 +475 1 1.92587 12.9087 13.6164 -8.16731 5.11551 18.4441 +476 2 1.30634 12.3949 14.1755 13.4846 7.44573 -7.00244 +477 2 2.13079 13.7319 14.1159 -1.95883 -16.9131 -9.84331 +478 1 9.29336 6.75339 14.7687 -19.1125 21.7104 1.76678 +479 2 9.711 5.9819 15.1082 15.9481 -24.452 8.13362 +480 2 9.58853 6.88119 13.8676 2.75751 0.822828 -8.36077 +481 1 15.2452 4.28737 10.7623 -0.225576 -4.08648 -1.74219 +482 2 16.1503 3.99339 10.8719 6.1947 -5.72264 -8.71474 +483 2 15.1717 4.92602 11.4736 -7.0877 3.5816 0.665059 +484 1 11.4391 6.24473 0.0517087 -15.4849 -28.4826 -7.88372 +485 2 11.5335 5.29025 18.4586 5.11122 21.8085 5.83846 +486 2 10.469 6.36117 18.7264 13.3105 4.99187 -1.92993 +487 1 18.4571 11.4845 14.9094 -8.14212 27.2991 -26.8701 +488 2 18.0442 12.0056 14.1458 10.7134 -26.1217 30.6713 +489 2 18.3691 12.0954 15.6567 -1.55188 -2.54901 -1.51407 +490 1 7.07006 9.2713 7.35429 3.52198 -23.4346 -4.90088 +491 2 6.57918 8.46088 7.59869 6.01934 15.522 -0.341791 +492 2 7.98054 8.95273 7.2441 -4.91945 6.78887 2.19469 +493 1 18.4213 15.3485 12.1512 14.6289 14.7183 -5.00343 +494 2 0.703338 15.6554 12.0361 -12.928 -5.55139 4.18882 +495 2 17.8805 15.9633 11.6295 -1.60931 -6.92771 2.64168 +496 1 16.5853 4.3259 5.32941 -3.23822 -14.2219 46.7572 +497 2 16.614 4.15863 6.32722 1.43031 7.89007 -40.0485 +498 2 17.5031 4.43236 5.0545 -4.12857 4.88068 -4.00684 +499 1 17.7656 3.15988 10.7489 -7.77815 -3.54726 5.22618 +500 2 18.6517 3.33727 11.1036 -6.02481 -6.41431 -8.69585 +501 2 17.7347 2.25304 10.4054 5.10772 5.83768 0.491016 +502 1 12.3532 18.6195 10.0845 2.26138 29.9542 0.82462 +503 2 11.4554 0.369133 10.2956 34.814 -7.7062 -6.49387 +504 2 13.0539 0.703372 10.1287 -31.4455 -25.8056 2.12568 +505 1 10.4062 9.7592 12.5463 4.94309 9.48659 9.1975 +506 2 11.1178 9.86775 13.2051 -4.84217 -3.21907 -8.75193 +507 2 10.4169 8.83 12.3092 -0.242296 -5.43122 1.67162 +508 1 0.754807 2.57366 7.2759 5.10959 9.37805 -1.17349 +509 2 1.15147 3.40426 7.59563 -2.53061 -11.14 3.70439 +510 2 0.94825 1.90755 7.95351 -0.370046 8.4477 -4.76995 +511 1 0.326852 15.3245 6.92393 7.78779 -47.7914 -15.9381 +512 2 0.478367 15.1955 7.87742 -3.54148 6.5065 -12.4551 +513 2 0.511792 14.4078 6.50445 -6.22026 47.2618 21.2659 +514 1 17.0448 6.87527 14.9011 7.50868 -3.64469 2.18783 +515 2 17.7829 7.50382 14.839 -4.82102 -5.02166 1.59119 +516 2 17.384 6.09018 15.3732 -3.19441 8.7454 -5.86774 +517 1 9.10521 12.4991 8.01627 -22.444 -7.37457 -9.07321 +518 2 9.5155 11.7197 7.59468 -6.97176 5.64777 -5.01838 +519 2 8.17012 12.5725 7.67989 31.3303 -7.17656 9.91942 +520 1 1.12679 1.65794 2.79756 -4.95635 8.46302 6.6874 +521 2 0.642552 2.15227 2.11219 8.6081 -1.07022 6.53976 +522 2 1.60228 2.28223 3.37541 -5.16033 -3.32404 -9.46208 +523 1 4.24509 15.0269 10.0531 -9.28044 4.63084 -2.70058 +524 2 3.93721 15.2031 9.15401 2.26907 2.00751 2.33164 +525 2 5.07496 14.5648 9.92961 6.13338 0.348707 3.17177 +526 1 7.39613 2.22212 14.8791 -10.1428 -2.73186 -2.62368 +527 2 7.12857 1.59843 14.1951 -0.211704 -1.85534 3.14611 +528 2 7.6308 3.01777 14.3992 6.19568 3.75469 -5.36272 +529 1 18.3005 14.5161 2.14907 5.30067 -9.26209 1.4902 +530 2 0.506128 14.8057 2.49377 4.6744 -0.083839 -4.04908 +531 2 17.8019 15.308 1.97101 -9.85855 11.1774 -0.48774 +532 1 10.0782 2.71092 12.8944 3.88974 -3.73664 -2.78909 +533 2 9.88925 2.05355 12.2072 4.3936 3.86452 2.74403 +534 2 9.31937 3.3006 12.9074 -3.94823 0.261307 -1.05017 +535 1 2.9306 8.79131 12.9512 -25.6961 -20.8645 -0.44372 +536 2 3.33593 9.62792 12.788 10.417 21.0465 -4.83397 +537 2 3.64632 8.1716 13.058 11.1871 -7.80414 6.67576 +538 1 3.17851 8.59155 3.78391 36.0219 9.48042 20.5594 +539 2 3.64638 9.17092 3.16182 -4.0064 -4.18597 2.27442 +540 2 3.67104 8.74964 4.63715 -24.9674 -6.25544 -24.3579 +541 1 5.79667 7.27872 8.61723 -5.158 -8.45889 2.36629 +542 2 5.76122 6.32524 8.453 -1.10357 3.40671 2.32671 +543 2 5.00318 7.4879 9.12925 4.38374 0.567505 0.838777 +544 1 14.9116 1.65307 1.84567 7.03031 -5.18946 -10.6018 +545 2 15.1062 2.45757 2.3139 -4.94852 6.93451 15.0643 +546 2 15.1691 1.84916 0.935056 -0.310542 -6.30296 3.0909 +547 1 8.67523 15.0369 0.613894 1.37845 1.1536 3.61737 +548 2 9.43682 15.0729 1.21213 -3.42809 -6.51916 3.89646 +549 2 8.00447 14.4711 1.03609 4.49017 7.63347 -1.72767 +550 1 15.3993 1.47022 7.19229 -20.8703 -2.58026 0.276614 +551 2 14.6837 0.967989 6.72584 19.4319 15.0033 11.4079 +552 2 14.9834 2.26826 7.5843 2.60239 -12.333 -11.18 +553 1 4.89704 12.855 18.4725 17.7474 3.66438 12.0852 +554 2 5.22521 13.0209 0.739851 -5.30909 -3.44768 -15.7686 +555 2 5.64886 13.1114 17.9131 -8.88833 1.88365 4.35483 +556 1 15.3966 8.71526 18.0579 -0.0737912 10.217 -6.92241 +557 2 15.7913 9.20885 17.3059 -4.72516 -6.1114 19.2356 +558 2 15.2466 9.35419 0.13361 -0.210218 -4.05252 -7.18588 +559 1 11.9654 3.16879 18.3684 -1.96391 -6.33771 9.57431 +560 2 11.8782 2.93896 0.667559 5.83177 -2.01678 -11.7343 +561 2 12.3624 2.38725 17.9444 -0.743858 8.0566 3.61175 +562 1 13.1976 12.733 5.19814 3.21154 2.81721 -3.88454 +563 2 13.6265 11.8743 5.11099 -2.80289 -1.59076 -2.45209 +564 2 13.3962 13.0406 6.08845 -1.48061 -3.43823 1.63358 +565 1 6.20234 7.07161 0.291392 8.37087 -8.50913 -15.2358 +566 2 6.21431 8.03007 18.9132 -3.08565 9.14852 3.50692 +567 2 5.28911 6.79756 0.384068 -8.05152 4.04277 7.5169 +568 1 17.755 15.8811 14.8809 -0.846783 4.67036 -1.95176 +569 2 16.8205 16.1356 14.922 6.46156 -5.25763 -8.70949 +570 2 17.9775 15.7319 13.9423 -7.01069 1.37948 9.8425 +571 1 13.0816 0.927432 16.7559 7.19813 -13.1533 1.9849 +572 2 14.0246 0.654652 16.7787 -14.5584 8.9122 1.46691 +573 2 12.5958 0.0867106 16.6751 4.09548 8.26383 -2.86333 +574 1 10.8721 14.5032 7.42074 17.8947 27.9436 -17.0444 +575 2 10.196 13.9242 7.71676 -22.829 -18.2345 11.9548 +576 2 11.6972 14.0514 7.58445 7.42519 -9.80791 -0.577526 +577 1 17.7647 8.42346 2.16939 -4.1598 1.60766 -5.89387 +578 2 16.8709 8.3975 2.49669 -12.234 5.23478 11.868 +579 2 17.7295 7.75318 1.48744 5.54579 -3.65645 -10.0136 +580 1 12.5773 7.79072 2.0332 1.0668 2.49746 -6.2566 +581 2 12.3914 8.73063 1.87761 -0.101344 -7.79782 -0.82295 +582 2 12.2276 7.2965 1.27263 1.31444 5.98607 5.5368 +583 1 12.0208 14.4615 10.4933 -27.7219 6.00234 -17.9899 +584 2 12.3406 14.2687 9.58404 -10.0812 4.98999 20.4987 +585 2 11.0483 14.7039 10.4238 33.6221 -8.97773 -1.58279 +586 1 6.69486 6.68845 15.5484 18.1135 9.98152 11.3143 +587 2 7.65688 6.85274 15.3559 -27.8703 -4.06425 5.81014 +588 2 6.48582 7.17335 16.3722 6.10572 -10.2019 -13.6564 +589 1 7.96659 4.39718 13.2272 4.51058 -7.9075 4.77481 +590 2 7.2893 4.70584 12.6248 -6.54048 3.46732 -4.14994 +591 2 8.21018 5.15068 13.7582 2.30488 10.1178 3.17748 +592 1 13.2671 12.2369 14.4347 -4.64765 -4.51239 1.04229 +593 2 13.0608 11.2949 14.304 4.07546 7.63325 0.952283 +594 2 13.624 12.5445 13.5893 -0.484314 -1.81518 4.66288 +595 1 14.4631 9.64208 7.37348 -3.22195 -17.9745 -8.46037 +596 2 15.2455 10.1455 7.54143 19.6931 12.3162 5.07411 +597 2 13.7594 10.075 7.84063 -11.2512 5.66435 9.63044 +598 1 12.6955 16.8004 3.38503 4.61351 40.5798 -15.2407 +599 2 12.79 17.4151 4.16128 -2.51333 -18.5745 -25.4999 +600 2 12.6728 17.373 2.55111 0.0132769 -17.6878 38.2975 +601 1 0.968812 6.96727 17.3326 -17.527 29.8281 -14.7856 +602 2 0.0966102 7.11435 17.7475 9.38145 -12.9539 -1.45746 +603 2 0.942675 7.56475 16.5473 6.51552 -11.7527 16.88 +604 1 12.9918 4.86088 15.7598 14.9884 1.53364 0.213735 +605 2 13.6417 4.12341 15.6561 -13.2544 27.5281 4.62454 +606 2 13.5036 5.69571 15.8607 -8.5455 -17.4296 -3.38108 +607 1 2.31456 3.41181 5.02375 -16.8072 14.5355 28.5245 +608 2 1.72499 3.01856 5.74541 26.0591 16.5367 -23.5498 +609 2 2.61813 4.33638 5.31016 -13.7452 -42.3935 -5.38282 +610 1 8.12877 10.8743 13.7813 26.8177 -26.1009 35.9685 +611 2 8.08888 10.4248 14.7095 5.12746 27.8083 -58.2879 +612 2 8.93477 10.511 13.3312 -19.2021 7.65314 13.0743 +613 1 13.0038 1.57226 13.2324 0.46489 2.31008 -10.6366 +614 2 13.6096 1.43937 12.4592 -18.9356 10.6634 16.2552 +615 2 12.412 2.34128 13.062 19.3329 -16.3736 -0.813643 +616 1 6.65189 13.7072 1.97939 -2.77776 -1.20266 13.9341 +617 2 6.01392 14.2112 2.53362 13.0928 -13.1372 -7.18637 +618 2 7.15166 13.1216 2.589 -8.8324 11.1791 -7.86511 +619 1 15.7768 6.33135 12.4394 -16.9523 -8.61752 -2.39927 +620 2 16.2545 6.83373 11.7966 11.5481 11.8457 -13.8092 +621 2 16.2346 6.49819 13.2509 8.584 1.06891 20.063 +622 1 16.7487 0.656157 9.53186 -1.89022 -32.3669 -10.6998 +623 2 16.6929 18.3191 9.69193 -1.14735 24.5709 0.588436 +624 2 16.3744 0.798362 8.64008 0.39513 1.76057 8.35052 +625 1 6.2256 11.6996 8.23382 -7.45249 -33.5883 4.29961 +626 2 5.41287 11.5766 8.79278 22.02 -5.73867 -21.2662 +627 2 6.53136 10.7979 7.88958 -15.1732 37.063 20.6987 +628 1 2.75779 8.608 0.340468 -48.3199 -4.33351 -7.97969 +629 2 2.08546 8.0585 18.4464 30.1073 27.602 24.3697 +630 2 2.23564 9.25518 0.892435 12.8354 -18.7139 -20.5564 +631 1 10.0773 10.2182 6.62419 2.67327 1.92209 4.62159 +632 2 10.5668 9.53044 7.10449 -1.07652 4.95909 -5.68289 +633 2 10.5655 10.3766 5.79827 -6.62323 -4.53969 7.46345 +634 1 6.84859 15.7294 6.8116 4.5172 -4.61086 -5.81045 +635 2 7.14728 16.2498 7.57791 -4.63192 -2.64256 -11.095 +636 2 7.17659 16.1616 6.00258 -4.95191 3.23702 9.76552 +637 1 6.62071 12.9207 5.93401 2.33655 2.8557 1.84805 +638 2 6.83452 13.8255 6.17261 -0.629609 6.79635 0.913528 +639 2 6.25462 12.5309 6.73716 -1.14115 0.401949 -5.14594 +640 1 16.7089 12.5339 9.77339 -0.869689 -1.39856 -8.71911 +641 2 16.7622 11.7819 9.15626 3.31473 10.0385 4.47785 +642 2 17.1611 13.2788 9.34464 -3.7572 -10.2702 6.17681 +643 1 6.29845 2.79213 2.75928 -3.20566 -14.4941 8.67087 +644 2 6.41489 3.68807 2.47435 5.42045 18.7619 -3.24562 +645 2 5.94058 2.32523 2.00482 -4.41542 -3.11109 -6.82659 +646 1 10.6289 2.95834 3.25769 -6.57134 8.8614 -3.08687 +647 2 10.3824 3.87829 3.42309 -0.834706 -5.50201 2.33367 +648 2 10.1446 2.71475 2.45701 2.51779 -3.35726 0.152255 diff --git a/examples/amoeba/dump.water_box.hippo.32.test b/examples/amoeba/dump.water_box.hippo.32.test new file mode 100644 index 0000000000..33463a3a5d --- /dev/null +++ b/examples/amoeba/dump.water_box.hippo.32.test @@ -0,0 +1,7227 @@ +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.67966 7.08769 17.9461 -19.3527 -13.639 6.25201 +2 2 7.80945 6.75579 18.2607 18.4949 11.1596 -6.01922 +3 2 8.72223 6.81424 17.0254 5.85599 -0.890166 3.45586 +4 1 18.5257 8.24445 6.83762 11.8085 12.5587 58.8481 +5 2 0.216892 7.89544 6.05003 10.8935 -14.9684 -50.5046 +6 2 0.444268 7.82601 7.5302 -15.2958 7.9793 -8.89884 +7 1 8.37906 18.5504 6.81463 25.5385 6.64228 -3.75624 +8 2 9.34042 0.098069 6.73406 -20.9151 -2.68951 1.38711 +9 2 7.93962 0.573676 6.26984 -0.656308 -0.308718 3.40946 +10 1 6.58995 1.84432 11.7198 46.6828 -15.9611 -12.5859 +11 2 5.88543 2.40231 11.9251 -37.6261 28.8114 18.1934 +12 2 6.18153 1.06275 11.3693 -6.58868 -16.6156 -5.55691 +13 1 7.1466 5.75358 2.33152 -56.1364 42.5085 -2.61462 +14 2 6.36812 6.12603 2.86268 40.1937 -23.4301 -4.21826 +15 2 7.02502 6.29465 1.5182 16.3021 -20.7884 10.9258 +16 1 16.2164 10.1388 16.1382 -32.0875 21.5958 16.7579 +17 2 16.9509 10.2747 15.5847 32.9015 -1.03241 -20.1636 +18 2 15.8498 11.0405 16.2399 1.98783 -14.756 2.71439 +19 1 10.6046 15.0374 2.30369 -8.13409 -25.494 -7.18668 +20 2 10.5292 14.3949 3.01849 1.41683 -0.603724 2.75561 +21 2 11.0236 15.78 2.70962 11.6057 19.8833 4.5888 +22 1 17.1624 8.24409 10.3708 13.0676 7.07862 9.73504 +23 2 16.5528 8.68798 10.966 -4.65968 7.37974 1.83434 +24 2 17.9421 8.82333 10.3208 -6.34155 -10.1937 -2.20396 +25 1 14.901 15.8652 16.3167 18.01 -6.87509 18.5636 +26 2 14.0225 16.1982 16.2525 -26.9236 12.7201 -6.50875 +27 2 14.9141 15.482 17.2099 2.63751 -6.05913 -7.59706 +28 1 12.1752 13.3771 0.408263 -11.3168 6.26442 9.98381 +29 2 12.0579 13.8465 18.23 5.67057 -4.50268 -16.0578 +30 2 11.6217 13.8904 1.00796 3.42507 -1.00312 9.73088 +31 1 9.27358 5.34243 4.05546 -35.2781 32.5984 16.8393 +32 2 8.64594 5.4665 4.83764 28.3783 -16.8163 -28.778 +33 2 8.74177 5.68615 3.30282 7.52493 -14.9247 9.48156 +34 1 1.83016 4.27673 11.6495 -21.1764 37.5598 -8.14901 +35 2 1.70328 5.22377 11.9391 6.02814 -28.7768 -8.29565 +36 2 2.40811 3.85345 12.2597 13.4728 -11.3181 18.3421 +37 1 1.96438 6.83299 8.3731 -11.1902 3.43717 -25.3738 +38 2 2.49614 7.21578 9.0563 9.35281 -0.190165 18.6039 +39 2 1.81128 5.90585 8.57354 7.84101 -3.79534 5.21373 +40 1 5.40557 4.38899 7.93274 -6.81526 4.7224 -2.63907 +41 2 5.53738 3.43895 7.78131 -7.79962 9.88898 0.533881 +42 2 4.75516 4.73491 7.29062 10.7858 -16.238 7.24535 +43 1 3.23 2.92842 17.5524 -0.538114 20.9936 16.7312 +44 2 3.93109 3.19827 16.9402 -0.965509 8.21721 4.01649 +45 2 3.00444 3.70897 18.1497 6.13449 -29.114 -23.6081 +46 1 7.4624 5.26283 6.13117 9.12728 4.25284 -1.73168 +47 2 8.02565 5.58849 6.88177 -24.817 -14.4341 -14.6054 +48 2 6.93508 4.45577 6.3254 16.0496 22.0303 12.0173 +49 1 9.77896 7.02384 11.9834 11.1205 -3.87253 23.9446 +50 2 10.2721 6.37256 11.5011 10.9222 -10.0302 -1.39678 +51 2 9.1532 7.31587 11.3499 -23.6433 13.1239 -20.7784 +52 1 14.1167 3.54999 8.03003 -30.7601 -1.60704 -37.9113 +53 2 13.4732 4.22413 7.73132 15.1608 -10.723 4.30178 +54 2 14.3809 3.80189 8.88487 12.8065 16.1495 34.678 +55 1 4.82329 17.2568 4.03846 -17.85 32.0436 -31.4073 +56 2 5.49315 17.973 4.01308 -7.71314 -24.6342 10.4391 +57 2 4.18746 17.5412 3.33843 10.9703 -13.5421 12.8553 +58 1 16.4918 16.6259 10.0493 29.9016 15.3745 -40.7533 +59 2 16.1673 16.3226 10.8594 -24.6786 -13.0437 37.8908 +60 2 15.9925 16.2084 9.33562 -4.01544 -1.82242 7.63759 +61 1 1.94489 4.93323 0.49791 29.1886 10.4759 3.59715 +62 2 2.55322 5.26335 1.2053 -17.2324 -10.4098 -15.9422 +63 2 2.08253 5.591 18.4408 -14.7087 -3.80383 3.81857 +64 1 11.816 13.3571 16.2711 -7.8083 1.12937 6.2001 +65 2 11.2371 12.6203 16.5671 13.3708 1.96491 -16.2063 +66 2 12.2446 13.1893 15.4079 -11.197 -7.32732 11.8633 +67 1 10.105 11.0651 16.9545 16.7158 -32.7784 1.37979 +68 2 10.5674 10.1947 17.1295 -14.0823 30.097 -5.45833 +69 2 9.25349 10.8067 16.5912 -2.99511 2.11526 2.57572 +70 1 11.7264 17.5421 13.4742 2.50122 -25.0158 -11.214 +71 2 12.2771 16.9836 12.8968 -8.91486 0.79877 6.23222 +72 2 12.1041 18.3936 13.317 1.59091 22.4782 2.42571 +73 1 6.33029 9.31911 12.2264 15.6898 -25.4439 -25.1534 +74 2 7.02603 8.96242 11.6353 -17.823 2.07037 1.33758 +75 2 6.81249 9.95941 12.7172 5.93051 22.1649 19.4162 +76 1 16.2187 12.7249 2.70186 -8.69715 -37.3569 7.82337 +77 2 17.0292 13.1566 2.50302 19.6243 18.7999 -9.68795 +78 2 15.4982 13.3357 2.61812 -8.61102 21.6356 1.57727 +79 1 0.637202 12.5625 5.84914 -32.6687 7.10288 -2.13707 +80 2 0.892312 12.5507 4.90771 -4.51242 -1.40786 13.4578 +81 2 18.3039 12.804 5.85329 37.5994 -4.88925 -6.97833 +82 1 5.19922 16.3781 18.5047 -7.71264 -0.634541 -12.9921 +83 2 5.80284 15.8543 17.9455 2.11468 10.7978 13.7187 +84 2 5.67034 16.9636 0.462296 7.23142 -5.58048 -3.24093 +85 1 0.510145 7.62945 4.0545 45.851 19.5686 -25.4796 +86 2 18.5719 8.14656 3.45296 9.61971 -16.7838 10.3831 +87 2 1.46496 7.74082 3.66917 -52.3954 -1.94356 25.3273 +88 1 3.14672 8.89584 6.52626 -54.2957 5.34018 -1.73828 +89 2 3.50609 8.59991 7.35294 9.18701 -2.26398 8.55435 +90 2 2.14573 8.92962 6.68203 45.3688 -0.563656 -9.64228 +91 1 7.30854 10.3037 16.1717 -0.0267506 0.140778 15.7468 +92 2 6.56213 10.4624 15.5802 1.32412 -0.384411 10.7132 +93 2 6.99303 10.278 17.1118 0.130505 3.94788 -23.0495 +94 1 11.1122 1.06968 4.98939 -2.83136 -16.8604 13.0177 +95 2 11.0776 1.97142 4.64864 2.2702 -4.31387 -11.6367 +96 2 10.7048 0.433547 4.37027 2.96408 14.9419 -2.56144 +97 1 4.45204 2.70061 13.2052 -8.32298 -31.9478 35.5434 +98 2 4.60333 3.05865 14.0914 -0.476624 15.5497 -15.2927 +99 2 4.38645 1.737 13.4626 0.207127 24.1129 -25.2696 +100 1 8.42792 10.0237 1.78469 -10.6267 -17.9408 16.848 +101 2 8.3405 10.6377 2.53622 4.43246 -2.98222 -4.40025 +102 2 8.49672 9.11244 2.17467 4.60711 29.3182 -9.45134 +103 1 10.5335 1.75383 15.546 -31.9958 -1.22726 0.532554 +104 2 11.3977 1.82718 15.9216 23.4057 -5.242 -0.0927752 +105 2 10.5608 1.78317 14.5837 3.34522 3.38855 0.282019 +106 1 2.77693 12.941 7.74821 -10.6415 2.34425 -2.27994 +107 2 3.28797 13.5733 7.23382 5.58977 0.334345 4.09149 +108 2 1.98704 12.8256 7.20013 5.22386 -8.52712 2.54059 +109 1 3.63517 11.6895 5.33963 -10.2259 -13.0028 -10.3717 +110 2 3.35385 11.0502 6.03137 4.73753 15.317 -16.6328 +111 2 2.8758 11.855 4.74058 11.3048 -4.09559 12.5928 +112 1 6.88803 14.474 16.8428 -13.42 9.46677 6.94107 +113 2 7.55973 13.8293 16.6383 4.5229 -1.76969 -1.40507 +114 2 6.60381 14.8838 16.0165 0.0834179 -9.06129 -0.120708 +115 1 14.1722 14.5374 3.41536 20.1951 -3.19134 -21.8839 +116 2 13.6514 15.2845 3.14096 -9.23852 13.3738 0.77613 +117 2 13.8512 14.2508 4.25439 -13.5451 -9.47926 16.7085 +118 1 8.28226 18.1809 16.0824 -9.43856 -15.6135 -5.07226 +119 2 8.77677 17.3494 16.3071 1.43839 31.5077 -5.33478 +120 2 8.7603 0.384816 15.9919 11.1327 -19.5096 4.24776 +121 1 4.73724 1.61643 4.90111 5.86874 37.6921 -30.6753 +122 2 3.96969 2.16837 5.15263 9.12039 -10.9712 -6.28456 +123 2 5.18465 2.1484 4.15475 -17.6049 -26.8232 41.7187 +124 1 15.1457 12.8616 16.4403 -17.0638 -11.2899 43.408 +125 2 14.6041 12.8692 17.2613 22.7365 8.03356 -12.6578 +126 2 14.49 12.6307 15.8136 -17.0236 -4.89604 -35.7974 +127 1 15.779 18.3837 16.786 48.5063 8.0766 44.3104 +128 2 16.5108 18.615 17.4688 -41.9285 -7.99937 -34.0327 +129 2 15.7694 17.4186 16.7687 -10.3466 2.2793 -1.1406 +130 1 1.1383 1.1331 16.5571 -3.54071 10.9478 5.94974 +131 2 1.96551 1.50352 16.9177 -15.9767 0.55296 -3.51275 +132 2 0.420521 1.53444 17.0916 21.5279 -7.8795 -5.43288 +133 1 18.0817 4.5907 15.863 15.8138 -19.1991 -2.64562 +134 2 18.5818 3.91936 15.3489 -11.6552 16.5822 9.8521 +135 2 18.5602 4.7339 16.6874 -1.16116 -1.56098 -3.02727 +136 1 12.22 16.9378 16.1148 -9.97587 -12.4224 57.0196 +137 2 11.409 16.6934 16.6676 29.0172 6.05041 -31.7989 +138 2 11.9646 17.3216 15.2917 -14.4882 2.9648 -22.1743 +139 1 15.8709 2.55221 17.9707 -3.56258 26.452 -16.7944 +140 2 15.7355 3.48355 18.2574 6.35046 -25.5765 3.86241 +141 2 15.6659 2.59235 17.0072 6.0189 -6.56803 19.8103 +142 1 6.70868 13.791 10.2637 1.94011 22.9489 3.02058 +143 2 6.59347 13.548 11.1958 0.710608 -4.45224 -7.92394 +144 2 6.58252 13.0514 9.6765 -3.73143 -16.591 0.344408 +145 1 10.146 18.2027 2.80372 16.894 35.9 -12.6825 +146 2 10.2207 0.331961 2.18345 -1.03174 -23.6422 14.9845 +147 2 9.26571 17.8868 2.67703 -18.7462 -7.34721 -7.1199 +148 1 2.97538 17.748 6.06078 -27.2244 1.77787 1.96995 +149 2 2.09399 17.6473 5.67013 1.23544 -3.46851 16.5241 +150 2 3.45883 17.8838 5.26396 32.1509 0.10025 -8.47089 +151 1 12.558 17.0134 7.97028 2.72879 -14.1128 -3.91884 +152 2 11.9572 16.2512 7.82085 4.20569 13.3061 15.6125 +153 2 12.4657 17.4524 8.83591 -10.4039 -6.95813 -9.08653 +154 1 14.8795 15.2862 8.28544 5.56082 -19.5077 38.9848 +155 2 13.9824 15.6136 8.40666 -1.04882 8.68143 -14.5015 +156 2 15.2312 15.4641 7.43118 2.2507 10.8701 -29.8329 +157 1 17.5429 18.3228 0.375372 -51.3852 -2.4253 -14.1847 +158 2 18.116 17.6308 0.128652 38.5367 -21.5025 -8.63787 +159 2 17.9698 0.288559 0.934677 24.3068 21.4661 19.9837 +160 1 0.910209 10.3712 1.41143 -2.71779 -52.992 43.3073 +161 2 0.158544 9.88347 1.87089 22.0109 19.7614 -26.7074 +162 2 0.565924 11.0969 0.944383 -22.7833 34.6337 -23.5778 +163 1 1.55407 12.175 3.31087 16.6578 22.9783 50.8488 +164 2 1.36245 11.4802 2.72234 -7.70692 -21.3552 -33.2695 +165 2 1.61623 13.0206 2.87285 -0.913798 3.83337 -14.7861 +166 1 0.543127 17.2543 4.88609 29.8094 34.6465 -52.7559 +167 2 0.11032 17.9772 5.31124 -19.8915 12.2203 12.8491 +168 2 0.420366 16.4266 5.2673 -10.0988 -43.8479 36.8786 +169 1 1.10053 1.01949 9.38768 20.7334 -4.84081 3.89797 +170 2 1.46081 0.575286 10.1589 7.03147 5.77442 11.7732 +171 2 0.265613 0.594128 9.34525 -29.6063 -3.3853 -10.3011 +172 1 16.8007 2.32783 13.2877 6.1037 15.2386 -31.0559 +173 2 17.0701 2.57314 12.3549 -10.0746 -10.076 30.4228 +174 2 16.4263 1.43993 13.282 1.60122 -3.62923 0.222317 +175 1 2.45231 15.8283 12.1942 27.8718 -10.8871 18.2649 +176 2 2.8623 15.5513 13.0537 -9.1784 7.03247 -27.4702 +177 2 2.91392 15.3801 11.4615 -3.34054 6.42182 7.24567 +178 1 16.435 15.531 5.9458 21.7194 38.3058 -21.2998 +179 2 17.3808 15.5177 6.20547 -16.0791 -6.59953 3.69269 +180 2 16.4147 16.2211 5.22063 -10.9707 -19.0563 26.084 +181 1 5.84547 5.02056 11.8065 15.5941 -20.7973 -13.2046 +182 2 5.55799 5.91374 11.8891 -11.5246 18.633 11.9833 +183 2 5.09 4.45915 11.9819 -3.94875 -1.81326 3.16792 +184 1 15.2214 4.86555 0.731755 -13.7826 -16.8748 28.0949 +185 2 14.6776 4.45845 1.47821 23.1081 18.7106 -26.9415 +186 2 14.6696 4.95834 18.5986 -11.4435 4.17379 2.92627 +187 1 16.3401 16.2933 2.11217 18.5695 -12.4905 -31.3072 +188 2 16.0666 16.7695 2.87319 -12.4192 21.1701 22.1863 +189 2 16.7601 16.9279 1.50378 -10.9162 -1.12869 10.7347 +190 1 0.305885 4.87877 3.79118 -7.51195 53.5881 20.4451 +191 2 0.299338 5.85541 4.09758 -3.10789 -46.5114 -24.0825 +192 2 1.16991 4.5635 4.03062 6.84312 -11.1831 1.05233 +193 1 2.92501 14.9782 15.0356 -4.41813 7.08234 41.1019 +194 2 3.0159 14.7264 15.9987 0.986861 -4.57119 -32.7424 +195 2 2.35392 15.7535 15.1247 6.41577 5.11218 -9.25191 +196 1 1.1115 14.5727 9.55731 53.3594 20.601 -11.7192 +197 2 2.08491 14.4157 9.46275 -24.0912 20.2308 -9.17401 +198 2 0.897072 13.7408 9.90248 -29.0631 -35.5955 19.1061 +199 1 13.6501 16.6688 11.5433 6.78983 17.7214 -9.74398 +200 2 13.4697 17.4567 10.9694 -2.9322 -22.903 16.7504 +201 2 13.5721 15.8897 10.9842 -10.359 0.342192 0.0202177 +202 1 4.73098 1.47842 0.720986 -5.29759 -7.25447 0.0447572 +203 2 4.27169 1.98826 0.034225 -5.56193 -3.14325 9.7343 +204 2 4.11741 0.788607 1.06182 6.25861 16.2271 -3.37713 +205 1 1.42158 18.4663 11.9139 -14.0127 27.0043 -17.9914 +206 2 1.21766 0.394331 12.6648 1.7087 -1.58128 0.41261 +207 2 1.94844 17.765 12.2423 13.0376 -22.9613 11.2697 +208 1 11.5498 10.1018 4.11619 27.4262 20.5676 -21.0421 +209 2 11.5687 10.5955 3.24216 -3.20948 -18.7647 28.9446 +210 2 12.4899 10.1059 4.45555 -29.515 -1.53007 -14.7279 +211 1 8.38254 12.182 3.76573 -26.3924 1.04105 6.81072 +212 2 9.25863 12.501 4.06076 -19.5654 3.48754 6.33549 +213 2 7.63736 12.4251 4.40785 41.4561 -5.4387 -17.0092 +214 1 14.3228 4.03714 3.29709 11.5996 0.889358 18.0886 +215 2 14.8928 4.14179 4.10547 -12.6664 -0.432988 -23.901 +216 2 13.4701 4.45558 3.48891 5.46089 -2.24129 3.2962 +217 1 5.58188 1.78199 7.50513 -33.666 -46.5708 42.0626 +218 2 5.0172 1.13958 8.12095 34.1345 40.5367 -42.64 +219 2 5.33078 1.59122 6.59529 1.4651 -1.13721 -3.53311 +220 1 17.9086 1.12503 4.88467 5.13037 -2.27617 -10.7476 +221 2 18.4038 1.54032 4.14207 -7.55128 -2.38968 19.1857 +222 2 17.6814 1.78344 5.55455 5.62983 -0.00428508 -6.93418 +223 1 6.83101 9.39303 4.49716 -12.9019 3.06885 -29.4929 +224 2 6.83675 9.57499 5.42715 5.2276 -1.57178 18.8103 +225 2 7.66807 8.99049 4.24996 8.60683 3.06936 7.19189 +226 1 2.71406 14.9654 1.962 -12.6433 -7.2797 -26.4735 +227 2 3.33343 14.7912 2.66354 11.3685 -5.36414 4.18623 +228 2 3.09502 14.6645 1.10257 -3.50464 10.9487 24.1748 +229 1 17.279 12.8803 13.1283 -18.5839 20.1434 9.0108 +230 2 16.4044 13.2339 13.3283 -9.51346 -21.2442 0.20606 +231 2 17.6948 13.7346 13.0834 29.6252 3.29486 -10.2855 +232 1 15.0196 10.5818 1.38314 -38.8036 -34.5801 -31.952 +233 2 15.5102 11.1963 1.85791 33.5109 39.8843 28.1173 +234 2 14.3351 11.0964 0.933298 4.14202 -6.46403 5.49191 +235 1 5.71789 6.95838 4.52856 4.11089 -29.6335 9.96606 +236 2 5.85266 7.87985 4.34179 3.17266 16.1428 1.23553 +237 2 6.44364 6.70841 5.13514 -12.5329 -0.461157 -7.94794 +238 1 8.12142 8.26262 10.159 -0.855146 6.49391 46.4818 +239 2 8.58519 8.93965 9.66877 4.4396 1.59282 -10.2318 +240 2 7.56021 7.74854 9.59836 -7.32825 -5.6782 -22.3885 +241 1 13.5311 18.2901 5.8079 -14.4364 -13.815 12.5854 +242 2 12.703 0.102298 5.56963 8.23181 2.14052 6.61043 +243 2 13.2939 17.6289 6.50758 2.60691 23.7973 -17.1373 +244 1 0.327324 2.56344 0.113251 2.62118 15.3541 1.11187 +245 2 18.009 2.52214 18.5736 10.3638 17.1812 4.70476 +246 2 0.724331 3.48299 0.160564 -23.8753 -26.7718 -0.881277 +247 1 12.6396 10.9599 9.76875 -60.0152 14.8867 -10.4701 +248 2 11.6552 10.7306 9.75031 40.0232 26.8927 -4.84212 +249 2 12.944 10.1383 10.0842 28.9404 -31.8014 10.6031 +250 1 0.789377 12.2851 11.08 12.3121 4.77193 16.7259 +251 2 18.4919 12.3017 11.2021 -18.2956 -1.72231 -7.06107 +252 2 1.09088 12.7637 11.8722 5.11265 -11.1183 -7.6011 +253 1 5.04567 7.2193 13.4912 -20.9717 -2.87687 -14.2941 +254 2 5.59899 7.84649 13.0247 8.94565 11.9067 4.64647 +255 2 5.48047 6.97898 14.3058 11.2978 1.34955 6.76892 +256 1 1.28609 6.99027 11.837 -50.3798 -70.0072 -12.7986 +257 2 0.481329 7.14037 11.2978 16.1889 0.462756 10.6855 +258 2 1.71601 7.79102 11.8803 28.8555 60.7949 7.07409 +259 1 15.4442 9.46712 12.3088 17.5488 35.5581 30.8368 +260 2 15.6103 10.4448 12.4444 -11.4156 -32.7422 -13.7105 +261 2 15.5582 9.10301 13.208 -6.0251 -0.167312 -17.6616 +262 1 16.6404 12.9744 5.44078 -0.477448 -16.7093 5.71929 +263 2 16.2955 13.8866 5.54247 6.71099 -18.3284 -17.4666 +264 2 16.51 12.593 4.54035 -5.5475 22.5864 15.6708 +265 1 6.17495 10.0683 0.210584 -22.0037 -7.52033 -29.8636 +266 2 5.35839 10.4511 0.557392 5.20282 -1.85407 -1.83494 +267 2 6.76092 10.0813 0.943985 23.8798 0.550264 15.5383 +268 1 12.3644 6.05734 4.04236 -20.6788 -35.4367 28.6454 +269 2 12.4738 6.70802 3.38308 -3.94744 31.282 -24.9442 +270 2 11.4212 5.77124 4.03221 20.7152 8.11174 -1.23853 +271 1 0.124733 12.8266 0.203961 1.72956 2.54106 -4.3392 +272 2 0.029974 13.5935 0.786871 -3.06107 -4.47794 0.0529132 +273 2 18.185 12.9963 18.0877 7.84157 1.57112 5.96497 +274 1 3.83931 18.5785 8.61972 17.9182 -8.56599 -14.1766 +275 2 3.58625 18.36 7.70531 -6.70328 -0.941099 8.10721 +276 2 3.07994 0.282626 9.06556 -18.5101 7.20519 -0.527908 +277 1 7.37599 17.2741 4.45241 45.8101 34.7343 -2.7797 +278 2 8.02493 17.9603 4.76808 -26.0663 -25.3607 -1.65849 +279 2 7.47725 17.3636 3.49301 -12.8678 -9.31687 6.18264 +280 1 9.20909 17.0315 12.2197 44.1268 -5.71549 17.0535 +281 2 9.48765 16.172 11.8421 -16.3435 15.6721 -2.29993 +282 2 9.99892 17.2887 12.7762 -25.7988 -5.61825 -13.0657 +283 1 13.3284 13.0292 7.94175 -52.6762 -33.6944 -6.73328 +284 2 13.0533 12.253 8.47808 14.3801 9.17086 -2.06391 +285 2 14.1985 13.2855 8.14946 32.3912 12.3835 13.183 +286 1 14.9871 2.94126 15.3478 14.7752 10.8142 -9.8874 +287 2 14.2243 2.52816 14.9303 6.27209 -7.10728 -1.53608 +288 2 15.7054 3.02501 14.6718 -21.9622 -5.02255 13.6584 +289 1 9.85637 15.4939 17.0026 6.25802 5.34328 -5.30261 +290 2 10.2013 14.6312 16.7411 3.93948 4.67059 -1.18803 +291 2 9.35728 15.3668 17.8085 -8.94372 -2.90673 5.88613 +292 1 11.2848 8.23994 16.5492 3.15289 33.2939 2.2253 +293 2 10.8315 7.75123 15.8747 -9.91387 -14.5897 -7.3255 +294 2 11.7506 7.62533 17.1016 4.32393 -13.5731 6.91104 +295 1 3.77097 18.1898 16.7118 5.96936 32.6304 11.943 +296 2 4.24576 17.6768 17.3569 8.77088 -19.0197 5.38959 +297 2 3.7978 0.441972 17.1008 -3.8528 -14.6362 -12.0582 +298 1 2.20581 4.09889 8.95874 4.57905 1.19328 9.26631 +299 2 3.00197 3.55544 8.74643 -17.2537 17.4622 14.7611 +300 2 2.10364 4.24367 9.94001 11.4926 -15.28 -28.3391 +301 1 9.9196 10.3581 9.75231 -27.966 16.15 -17.0738 +302 2 9.34403 11.1055 9.40387 24.0849 -21.7639 18.0289 +303 2 9.87032 10.282 10.7171 1.16507 9.52838 -7.01624 +304 1 9.73405 0.807167 10.8572 18.2139 21.6835 4.91261 +305 2 9.58177 18.5811 11.2204 -14.9491 -12.8069 -2.84973 +306 2 9.10878 1.03014 10.1675 -9.37034 -6.01821 -3.77915 +307 1 9.18221 15.2247 10.2123 -19.1642 -10.2407 -19.6365 +308 2 9.04674 16.0847 9.7631 0.663926 -17.4388 12.4081 +309 2 8.3908 14.6843 9.94105 22.9839 14.6501 17.4764 +310 1 1.00316 9.27987 10.329 14.3691 -27.2472 -11.0896 +311 2 1.16727 10.1904 10.5724 12.779 8.1681 -2.56256 +312 2 1.84996 8.76119 10.1498 -30.7163 35.51 10.5854 +313 1 16.8004 4.89338 8.19813 23.5039 -12.6505 29.7165 +314 2 16.1748 5.31624 8.83318 15.8467 -9.35353 -17.5774 +315 2 17.4877 4.38941 8.71628 -29.2517 16.802 -13.3541 +316 1 14.6379 14.6893 0.402347 -11.159 -0.978579 14.7724 +317 2 14.9609 15.3376 1.05877 0.0769081 -12.0935 -6.53519 +318 2 13.9048 14.1906 0.841144 15.9383 15.9909 -14.4014 +319 1 3.51181 11.0525 9.63829 2.1739 12.5105 -11.7746 +320 2 3.41507 11.3617 10.5484 4.86707 2.92948 -3.5212 +321 2 3.25155 11.8076 9.06383 -0.0479228 -15.275 7.06779 +322 1 11.0289 10.8695 1.26208 17.169 21.0662 -6.34954 +323 2 11.1535 11.716 0.753779 -4.03889 -27.9068 14.1765 +324 2 10.1142 10.5923 1.16471 -3.02205 2.54599 -1.38039 +325 1 13.2239 7.06188 12.8977 -30.3793 3.52384 -4.06516 +326 2 14.1381 6.84046 12.8922 25.6531 -5.59605 1.27225 +327 2 12.7471 6.22139 12.9668 3.13335 6.34025 -4.15647 +328 1 9.62584 1.88878 0.937813 20.0839 -1.09549 37.2578 +329 2 8.77484 2.11506 0.623903 -26.2152 1.3675 -15.013 +330 2 10.1764 1.70882 0.191067 9.10224 -0.512606 -16.4895 +331 1 10.6054 13.537 4.7508 -3.45661 -5.20977 -1.23778 +332 2 11.3208 12.9359 5.04367 -5.78837 16.6981 -6.98771 +333 2 10.4128 14.1619 5.47507 11.2154 -13.4565 -5.70688 +334 1 14.2525 1.6915 10.8868 25.1006 21.2848 4.13062 +335 2 15.0842 1.26497 10.6465 -4.75627 -8.22365 -3.1417 +336 2 14.5069 2.62992 10.8824 -13.5101 -4.08816 2.36647 +337 1 14.6678 12.4248 11.7157 -12.7858 -12.3306 -9.5252 +338 2 15.5574 12.5766 11.3177 -24.032 -11.5318 -4.29299 +339 2 14.0022 11.9667 11.1187 32.4402 16.632 10.9337 +340 1 8.24065 5.08218 9.78509 -7.81525 41.6802 29.5679 +341 2 7.45364 5.10173 10.3836 16.236 -11.1581 -20.3292 +342 2 8.36822 4.22882 9.41503 -10.4798 -31.0118 -7.50393 +343 1 1.59893 16.8132 18.3262 1.78713 43.6046 -19.4726 +344 2 1.99225 17.1675 17.4932 -13.4068 -2.95443 18.1753 +345 2 1.72693 15.8931 18.2458 9.12037 -33.6792 3.80865 +346 1 1.43382 17.2563 15.3383 70.3372 -10.1908 -13.5082 +347 2 1.32309 18.1562 15.5759 -5.39176 26.6374 11.2222 +348 2 0.623143 16.841 15.3782 -64.6751 -20.2725 0.847241 +349 1 3.73599 5.55499 6.2196 -13.8181 39.8005 -2.84681 +350 2 3.32092 6.26594 6.76194 2.21889 -20.7758 -8.723 +351 2 4.19567 6.05321 5.52665 5.67395 -4.434 2.61268 +352 1 12.357 9.41487 14.1826 15.3987 -29.3966 1.09302 +353 2 12.9591 8.63784 13.9021 -33.8501 34.209 16.2235 +354 2 11.936 9.15457 15.0346 16.6427 1.77305 -15.4117 +355 1 4.0362 15.2647 6.90572 33.8672 24.728 -7.08093 +356 2 3.45744 16.0249 6.7945 -6.17655 -1.99751 -5.28974 +357 2 4.92941 15.6518 6.66696 -29.006 -22.9584 9.78444 +358 1 0.606517 8.56128 14.8606 9.39684 15.8059 -8.30397 +359 2 0.498099 9.52604 14.9437 -1.87135 -9.61679 5.58044 +360 2 1.28855 8.50016 14.167 -9.83185 -6.21013 7.33103 +361 1 12.9763 8.3683 10.3434 1.19405 4.03237 -29.9304 +362 2 13.7163 7.90436 9.89822 -7.22584 1.47622 17.5396 +363 2 12.9003 8.0957 11.2534 8.23718 -11.529 10.7869 +364 1 15.2983 7.63672 3.47583 -36.323 -26.5913 31.5529 +365 2 14.5024 7.10501 3.29647 15.7237 15.5958 -25.1442 +366 2 15.2922 7.47095 4.43335 26.8259 14.207 -3.84044 +367 1 17.3208 6.63818 0.028906 -16.9884 17.5938 -6.80353 +368 2 16.7479 6.05403 0.554933 4.15554 3.30118 -7.73843 +369 2 16.7141 7.27151 18.2009 11.1968 -20.2911 18.275 +370 1 8.79355 6.92545 7.84172 -17.9944 -26.8715 17.7017 +371 2 9.63968 7.32585 7.85068 34.0918 14.4557 -5.0304 +372 2 8.77688 6.39871 8.67404 -5.99252 8.25367 -18.4431 +373 1 12.3209 0.607808 1.1741 -9.70621 -1.67076 -6.18378 +374 2 12.995 1.15082 1.58835 11.8921 -6.95349 3.94176 +375 2 12.79 18.5825 0.66073 -1.23695 5.23567 5.50046 +376 1 5.68514 15.097 14.5145 3.67475 30.0662 -16.0184 +377 2 4.72797 15.1695 14.4772 -3.92865 -1.97247 7.85561 +378 2 6.02476 15.8935 14.032 -4.97132 -21.5573 17.6103 +379 1 3.822 6.53853 1.67803 9.4136 -3.73603 -11.0507 +380 2 3.54968 7.33117 1.17576 -2.2757 -10.4776 17.1213 +381 2 3.81642 6.7886 2.60252 -0.785086 8.11893 4.5328 +382 1 3.89262 11.6088 12.227 13.3033 3.31132 5.82178 +383 2 4.72051 12.1032 12.348 -1.72331 -9.21471 -1.78635 +384 2 3.26281 12.0921 12.7526 -14.3078 7.33513 5.3451 +385 1 5.45444 3.88172 15.8755 10.9934 63.7886 22.8921 +386 2 5.90627 3.24049 15.3708 25.1493 -29.4334 -15.1609 +387 2 6.11665 4.65725 15.9739 -37.1513 -37.4972 -5.17498 +388 1 14.4636 10.317 4.39501 8.04256 -17.7362 -43.5508 +389 2 14.9051 9.88853 5.13417 -2.05112 -4.59794 0.583625 +390 2 14.7084 9.81768 3.53446 -13.0506 20.827 46.8358 +391 1 7.94949 17.2895 9.24469 -12.4073 10.6503 -4.49958 +392 2 7.23447 17.5423 9.86969 11.4984 0.663317 -18.2334 +393 2 8.01085 17.8889 8.47627 -8.74254 0.310971 13.2931 +394 1 4.4986 14.4237 3.96317 22.7921 6.59984 27.2073 +395 2 4.89523 15.3318 4.14709 -15.7294 -33.8816 -1.82578 +396 2 4.80237 13.7713 4.67129 -10.4496 32.1184 -24.135 +397 1 14.3358 7.38467 15.7635 24.4704 6.70756 7.84838 +398 2 15.2401 7.23754 15.391 -26.2451 3.74497 13.7384 +399 2 14.4998 7.83446 16.6232 -7.00308 -11.7114 -18.5693 +400 1 2.86875 18.2246 1.90934 8.22952 29.9251 46.5059 +401 2 2.54447 17.7626 1.17928 -17.7355 -34.6574 -39.0362 +402 2 2.08284 18.4154 2.45796 15.223 4.61378 -9.70941 +403 1 7.96139 1.61197 4.52525 29.4796 -3.5692 28.5612 +404 2 7.4985 1.83317 3.72811 -4.47294 12.8461 -13.1797 +405 2 8.84188 2.051 4.57628 -23.8244 -8.06079 -10.6756 +406 1 2.69247 14.1251 17.7583 -39.7925 -12.5472 14.0506 +407 2 1.78944 13.8074 18.0556 30.3506 3.26472 -13.0537 +408 2 3.33089 13.517 18.1683 -2.67461 8.7222 -7.81087 +409 1 0.711797 1.68055 13.8626 44.8563 0.102291 -15.8697 +410 2 0.854596 1.56791 14.7929 -2.34617 -4.64243 17.7358 +411 2 18.4557 1.86826 13.7064 -36.5874 5.33291 1.35002 +412 1 4.5582 18.5986 13.9691 17.69 -10.1212 -17.3986 +413 2 5.37614 18.0918 13.7297 -17.5363 18.7277 11.6893 +414 2 4.4096 18.4453 14.9034 -4.80692 -4.44744 5.40837 +415 1 7.10973 0.453475 18.3742 -17.6731 43.6393 33.9394 +416 2 6.99644 0.098599 17.5235 3.55611 -15.5456 -38.0778 +417 2 6.34312 1.05085 18.5323 11.5496 -19.3687 -0.295067 +418 1 16.0934 18.4421 14.1505 -13.5696 -24.3411 -34.6818 +419 2 15.444 17.7866 13.7542 20.5302 26.3107 23.9987 +420 2 16.0379 18.4915 15.109 -11.2087 -0.403296 -0.42938 +421 1 10.1156 4.52417 16.2956 -63.5341 -10.6596 -28.1335 +422 2 10.9808 4.34247 16.5381 54.6034 1.03427 17.4186 +423 2 9.84863 3.69679 15.8473 1.5569 12.8802 9.55133 +424 1 15.8226 17.9425 4.41327 -12.7412 7.89699 33.5898 +425 2 16.5547 18.5732 4.53052 -9.15632 -3.64108 -2.38506 +426 2 15.1071 18.2295 5.06915 28.1993 -15.1976 -35.9746 +427 1 6.9246 17.3574 13.7412 41.9162 15.5861 -1.52717 +428 2 7.49648 17.8115 14.4369 -23.1807 -22.4309 -23.3681 +429 2 7.52703 17.1963 12.9658 -13.588 5.84324 25.6525 +430 1 13.2892 6.57209 6.73437 -45.0771 -7.84691 9.23056 +431 2 14.2146 6.66317 6.83486 35.9508 1.69852 -11.4068 +432 2 13.0394 6.38579 5.82242 8.43649 1.47489 -3.25235 +433 1 7.6616 2.3861 9.17526 8.07841 -8.24756 -37.8228 +434 2 7.32169 2.39592 10.0555 -17.554 -3.79201 20.6206 +435 2 6.95914 2.1022 8.53308 18.9972 7.96045 22.8376 +436 1 15.1464 14.8771 13.6482 -9.08859 5.19149 1.30171 +437 2 15.0308 15.0223 14.6069 -2.64384 -0.244686 -12.5428 +438 2 14.3194 15.1152 13.1798 15.9342 -4.32482 12.4068 +439 1 9.29105 8.34315 3.70472 25.3147 -22.6228 7.1656 +440 2 10.1776 8.75859 3.73678 -14.6049 0.788849 -0.227964 +441 2 9.48378 7.39942 3.88081 -7.38963 16.6026 -2.51653 +442 1 17.6854 13.4687 16.4528 1.20699 34.422 -16.619 +443 2 16.7357 13.4337 16.3398 -3.15338 -8.61752 5.60033 +444 2 17.8844 14.3284 16.0065 4.30498 -21.0483 11.9174 +445 1 5.04883 10.6547 2.58751 21.171 -14.0773 3.70172 +446 2 5.87017 10.3468 3.04382 -23.0848 5.17759 -4.78185 +447 2 4.55197 11.1441 3.22928 -5.68041 9.33128 13.9497 +448 1 3.70566 8.3683 10.3381 2.8322 -31.099 -4.13864 +449 2 3.86061 9.29726 10.2176 3.71195 18.7597 0.626964 +450 2 3.86652 8.14601 11.2715 -4.70232 11.1023 -9.34814 +451 1 16.1079 7.11641 6.33859 19.1617 -15.4194 -14.8444 +452 2 16.7241 7.70559 6.80408 -7.69122 -6.37409 -7.38138 +453 2 16.6678 6.33083 6.12136 -24.1396 12.8226 8.63966 +454 1 15.2027 7.00502 9.1117 -12.4455 33.5656 -30.1004 +455 2 16.009 7.42176 9.46585 -11.7729 -5.93044 -7.51071 +456 2 14.9881 7.51375 8.25647 14.3105 -22.443 40.0586 +457 1 6.4525 13.1649 12.9201 -14.4212 4.62434 6.2224 +458 2 7.2977 12.7289 13.0561 -0.519457 -3.7562 7.19322 +459 2 6.25327 13.7237 13.7059 9.03992 -10.4089 -22.4145 +460 1 12.1145 4.49786 13.0694 60.1541 40.3897 -0.599702 +461 2 12.3852 4.68406 13.9868 -12.8154 -8.572 -1.53547 +462 2 11.3952 3.9317 13.0199 -51.9002 -33.7145 4.15206 +463 1 11.3323 8.18365 7.8522 33.2694 0.481688 12.7059 +464 2 12.0901 7.73501 7.43634 -16.2057 -1.97452 -6.97761 +465 2 11.7651 8.45102 8.68662 -20.5523 -0.0583287 -5.01537 +466 1 17.1666 10.776 7.42179 36.6255 -17.1838 -28.5238 +467 2 17.7906 10.0723 7.08441 -19.5131 16.2155 23.227 +468 2 17.2793 11.4524 6.73733 -13.1225 1.2547 8.82205 +469 1 5.22802 18.1471 11.05 -26.218 -15.3265 2.15414 +470 2 4.73762 18.1049 11.901 9.27461 0.443739 -18.2338 +471 2 4.62535 17.7417 10.374 18.9971 14.5949 15.121 +472 1 7.56653 17.6363 1.80821 2.05543 -3.48119 51.3305 +473 2 7.65741 16.7768 1.42856 8.63412 -18.3953 -16.9352 +474 2 7.35855 18.2549 1.13994 -1.30452 14.3677 -27.7338 +475 1 1.85092 12.9256 13.6076 17.4877 19.0754 23.2488 +476 2 1.72104 12.4156 14.4258 -6.17153 0.259213 -13.4945 +477 2 2.19932 13.7866 13.9501 -9.51965 -23.6336 -9.57422 +478 1 9.73868 6.79159 14.8001 -20.4051 42.5069 -0.796717 +479 2 9.95236 5.95211 15.1529 11.7083 -38.3225 9.01974 +480 2 9.967 6.84408 13.8723 6.06139 -4.97285 -7.43337 +481 1 15.2087 4.3972 10.7794 -26.9028 -24.0998 -25.0358 +482 2 16.0082 3.89203 10.8637 24.0661 5.32644 6.50358 +483 2 15.2102 5.16148 11.3322 8.70888 13.5856 17.3899 +484 1 11.1963 6.12482 0.150068 -24.122 -22.6006 13.7234 +485 2 11.2381 5.20796 0.481504 11.6671 13.7026 -10.2768 +486 2 10.2374 6.21547 18.6186 16.3103 12.5014 -3.12394 +487 1 0.19533 11.3359 15.1413 -21.6592 10.769 -30.7731 +488 2 18.4021 11.874 14.3993 14.4722 -20.1415 31.2795 +489 2 18.4481 11.661 15.9631 4.68348 9.49999 -5.94609 +490 1 7.06882 9.13032 7.26059 -22.6631 -3.09615 15.424 +491 2 6.55985 8.40099 7.69941 15.0645 18.9564 -17.5163 +492 2 7.9725 8.82922 7.21375 6.85038 -6.33336 0.902711 +493 1 18.4578 15.4507 12.3537 6.97015 0.808933 -7.22971 +494 2 0.776651 15.5698 12.2511 -16.5258 -3.56518 7.28193 +495 2 18.1456 15.6789 11.4721 -4.11121 -1.28038 2.68538 +496 1 16.5694 4.36967 5.25107 2.45626 -29.8761 41.2812 +497 2 16.7744 3.81151 6.06026 -19.4928 29.4804 -23.4548 +498 2 17.3898 4.32671 4.78168 14.6436 6.44337 -19.6343 +499 1 17.788 3.06911 10.7078 8.19486 16.3181 17.0759 +500 2 0.075758 3.1322 11.0257 -18.3141 -4.46618 -10.1687 +501 2 17.6332 2.20749 10.3226 7.04824 -10.7221 -5.22745 +502 1 12.3142 0.064083 10.1758 -16.6046 52.5698 5.40656 +503 2 11.3746 0.384648 10.259 27.2889 -19.3162 -0.832384 +504 2 12.8178 0.919304 10.3228 -10.5773 -40.3011 -9.47381 +505 1 10.3666 9.83315 12.2981 15.5663 4.35939 24.9446 +506 2 11.1015 9.85063 12.955 -12.9587 3.49885 -14.3711 +507 2 10.1328 8.91188 12.2898 -2.48305 -14.5784 -4.85859 +508 1 0.463654 2.82678 7.01839 21.5285 29.229 11.0876 +509 2 0.875324 3.58845 7.48211 -15.1018 -9.47019 -10.8481 +510 2 0.770257 2.12665 7.58365 -2.10845 -18.3887 2.87796 +511 1 0.478371 15.2358 6.91004 -5.05906 -57.415 8.40739 +512 2 0.585298 15.6463 7.75647 1.85019 10.3725 13.8373 +513 2 0.556531 14.2524 7.18353 -2.63305 52.383 -27.2731 +514 1 16.9534 7.00251 15.3394 -15.9191 6.08615 -6.45156 +515 2 17.6338 7.63543 15.0899 14.1822 -6.8729 3.83609 +516 2 17.3093 6.19568 15.7235 10.8839 2.85836 -7.52482 +517 1 9.0001 12.4151 8.13768 -31.1102 30.9609 25.8163 +518 2 9.37386 11.8218 7.49742 -5.17233 -14.4246 -22.3971 +519 2 8.02402 12.632 8.03373 38.2843 -19.0142 -6.47162 +520 1 1.27238 1.95406 3.05803 -13.5483 -7.94682 -18.4152 +521 2 1.26084 2.61511 2.34121 0.274888 -9.5029 12.9388 +522 2 1.89031 2.22344 3.73293 6.76618 11.1556 -0.474465 +523 1 4.13907 15.1156 9.62039 -21.6353 8.89781 12.928 +524 2 4.07003 15.1439 8.65747 6.73796 -2.17255 1.87071 +525 2 4.96029 14.7006 9.86457 13.8731 -5.89958 -3.36363 +526 1 7.17628 2.17866 14.5671 10.1969 15.6665 0.500505 +527 2 6.99528 1.68402 13.7698 -5.58163 -4.27811 -6.1139 +528 2 7.62131 2.98432 14.249 -3.31044 -9.5634 8.35677 +529 1 18.6082 14.7131 2.1481 32.6395 -16.0207 -3.46113 +530 2 0.838003 15.1297 2.25966 -5.15041 -8.02703 -3.38947 +531 2 17.988 15.3544 2.42675 -27.9684 22.1971 4.74449 +532 1 9.94138 2.79524 12.9422 16.7157 -19.9527 -5.96647 +533 2 9.79404 2.1456 12.2228 -2.63367 12.9584 8.66897 +534 2 9.17835 3.36299 13.0326 -7.96092 5.51528 -6.54514 +535 1 2.80444 8.90955 13.0076 -17.7822 -13.1167 0.317539 +536 2 3.06361 9.80599 12.872 10.5962 22.9278 -4.25378 +537 2 3.5122 8.48618 13.4775 15.1932 -9.60442 7.00981 +538 1 3.236 8.3574 3.63664 -2.86765 -22.2709 68.2353 +539 2 3.45085 9.0718 3.07326 14.564 28.9211 -13.7717 +540 2 3.47645 8.58669 4.60794 -11.4307 -4.68562 -51.1711 +541 1 5.62853 7.18594 8.51094 8.63755 21.4894 2.16978 +542 2 5.46784 6.31815 8.13889 -3.95344 -9.53044 10.3317 +543 2 4.96415 7.47792 9.15047 -3.24726 -12.0183 -2.29801 +544 1 14.8757 1.26039 2.01768 8.95967 6.82752 -28.1452 +545 2 14.9353 2.01952 2.56559 -6.40438 15.8227 28.9683 +546 2 15.2784 1.60993 1.21235 -4.35761 -14.1118 -5.79377 +547 1 8.22892 15.2012 0.850139 10.8537 -12.6178 7.38979 +548 2 9.02213 14.9338 1.33488 2.38301 14.3333 -0.830013 +549 2 7.55366 14.6663 1.27665 -9.08858 2.03607 -6.2405 +550 1 15.6387 1.34587 7.23673 -38.2068 -12.1482 -8.38322 +551 2 14.9277 0.724731 6.91269 26.6184 17.4884 8.18161 +552 2 15.1173 2.1119 7.53894 10.4663 -3.86302 -4.52487 +553 1 4.90142 13.0959 18.5232 17.6249 -4.01801 23.9701 +554 2 5.32755 13.082 0.76977 -10.7656 0.632793 -19.6876 +555 2 5.44764 13.7122 18.0259 0.499955 -3.74815 -4.96885 +556 1 15.3368 8.46948 18.1479 21.2409 26.352 -19.7425 +557 2 15.8061 9.12264 17.5623 -15.5364 -21.5252 11.6976 +558 2 15.3318 8.91689 0.353875 -5.84476 0.442576 5.05054 +559 1 12.0708 3.01842 18.3809 -8.91332 38.2285 -17.9492 +560 2 11.9316 2.65996 0.60646 7.08072 -18.979 4.32412 +561 2 12.6022 2.47389 17.7995 4.78982 -18.1658 8.07002 +562 1 13.2139 12.6752 5.17768 -9.57044 10.0795 -9.57129 +563 2 13.7464 12.0348 4.69253 1.60656 -5.44915 8.62561 +564 2 13.2564 12.5123 6.11793 10.4898 -3.48459 7.66387 +565 1 6.05443 7.0356 0.031519 0.0605761 -19.9038 6.17744 +566 2 5.93935 7.95118 18.5019 3.71712 34.2187 -1.98634 +567 2 5.39095 6.86665 0.702638 -7.83388 -10.1683 0.476271 +568 1 17.7528 16.0276 15.0213 -25.9758 6.2762 6.79882 +569 2 16.9476 16.5457 15.105 3.54626 -1.67183 20.5845 +570 2 17.7479 16.0055 14.0813 22.8568 -13.146 -30.1028 +571 1 13.196 0.994907 16.5363 6.37162 1.07879 13.9702 +572 2 14.1481 0.997912 16.7614 -14.4757 -4.73392 -6.84542 +573 2 12.8833 0.094199 16.7238 3.07394 5.84273 -8.05351 +574 1 11.1253 14.5647 7.20271 13.6513 20.7581 -19.5035 +575 2 10.4007 14.3183 7.72981 -32.979 -9.13798 24.3252 +576 2 11.7186 13.8255 7.26943 15.8912 -3.80541 2.99114 +577 1 17.5081 8.62849 2.08107 17.5857 37.593 18.6886 +578 2 16.6801 8.63471 2.55495 -11.5266 -11.0229 1.73392 +579 2 17.5233 7.88242 1.516 -4.85302 -28.502 -20.2632 +580 1 12.3547 8.01168 2.02213 2.8693 7.47745 -2.1033 +581 2 12.2384 8.8582 1.54611 -1.5199 -14.1485 9.25757 +582 2 11.9739 7.3152 1.48261 -4.60849 0.564674 -12.802 +583 1 11.8761 14.6165 10.3364 -1.28632 -27.1744 -11.0444 +584 2 12.1004 13.7873 9.81464 -15.5434 34.4502 21.6186 +585 2 10.8993 14.6888 10.473 22.8986 -6.0814 -12.7032 +586 1 6.89524 7.05211 15.6117 2.70483 5.93472 10.8866 +587 2 7.81004 7.26536 15.3122 -19.1207 -0.823892 9.8847 +588 2 6.66676 7.54167 16.4408 15.3743 -10.0989 -25.4065 +589 1 8.00326 4.73593 13.4743 46.2088 18.1039 21.0673 +590 2 7.23337 4.7302 12.9572 -37.1051 2.19442 -26.1447 +591 2 8.40671 5.62958 13.343 -9.63909 -26.9075 5.20654 +592 1 13.4128 12.1818 14.2522 -5.46405 -2.8504 7.05596 +593 2 12.9414 11.3292 14.2657 10.1901 3.29349 -5.65079 +594 2 13.7875 12.315 13.3696 -1.58979 -2.51674 3.72795 +595 1 14.8395 9.42189 7.30548 -10.1492 -33.0314 -14.9507 +596 2 15.7087 9.765 7.42505 18.3001 17.1245 4.25051 +597 2 14.2269 10.0768 7.57319 -16.3703 19.68 11.0075 +598 1 12.6526 17.0686 3.07252 -25.5483 38.6692 13.4046 +599 2 12.8376 17.5237 3.93373 3.7914 -19.7635 -24.6942 +600 2 11.9913 17.6958 2.63477 29.3498 -30.5169 14.5322 +601 1 1.15545 7.13838 17.4647 -1.30818 10.8795 -24.4228 +602 2 0.330359 7.36323 17.9184 3.51096 -10.352 -1.0007 +603 2 1.05514 7.47868 16.5422 2.6229 -4.15873 21.1004 +604 1 12.7562 5.15096 15.6457 46.9745 -3.15458 16.4241 +605 2 13.4512 4.55662 16.0315 -23.8856 11.8204 -16.5269 +606 2 13.2414 6.00335 15.5788 -13.869 -10.6853 0.37407 +607 1 2.53993 3.38757 4.97618 -24.4059 44.0626 48.9955 +608 2 1.7609 3.18232 5.58922 29.5313 1.39757 -24.0522 +609 2 2.84154 4.31546 5.27885 -6.94106 -48.8689 -12.2378 +610 1 8.33186 11.2983 13.4548 -25.447 4.99647 44.923 +611 2 8.4244 11.0562 14.4444 7.04045 1.38295 -54.395 +612 2 8.91168 10.8786 12.8197 20.7237 -12.5345 14.2107 +613 1 12.8689 1.31514 13.3384 4.70567 59.9078 -15.5432 +614 2 13.42 1.58034 12.5659 -9.46235 -19.1343 13.2352 +615 2 12.4231 2.17844 13.5496 8.70338 -32.6779 -3.58081 +616 1 6.34008 13.7169 2.14963 -19.3306 -6.11379 22.757 +617 2 5.63978 13.877 2.82959 17.9638 4.85668 -21.8758 +618 2 6.88351 13.0442 2.56282 8.57629 -2.48731 -1.94932 +619 1 15.9206 6.61444 12.7992 -23.3103 -26.3741 2.68057 +620 2 16.3106 7.25195 12.2393 16.9755 20.6681 -18.7226 +621 2 16.4213 6.59661 13.608 7.79648 1.05266 12.4236 +622 1 16.8298 0.712824 9.59482 4.79811 -22.8344 -3.47194 +623 2 16.8791 18.3713 9.72616 -6.98639 26.8255 -1.99774 +624 2 16.5452 0.8605 8.67269 -2.39382 -2.67689 10.2173 +625 1 6.14624 11.7631 8.37671 0.189841 -56.9827 6.97012 +626 2 5.32447 11.4591 8.84151 16.7156 13.8425 -13.046 +627 2 6.64226 10.8931 8.20176 -19.0535 39.3101 2.14415 +628 1 2.88754 8.61261 0.453821 12.2401 -11.553 -23.675 +629 2 2.45212 8.04764 18.3917 -4.84247 31.247 26.7064 +630 2 2.34875 9.28564 0.895642 -13.4946 -8.81401 -13.4914 +631 1 10.1674 10.4623 6.50123 4.87464 -2.88608 -13.8248 +632 2 10.6087 9.69731 6.89122 -0.620763 2.00125 4.93232 +633 2 10.4694 10.4636 5.56932 -5.34739 2.02001 15.3519 +634 1 6.7142 15.6951 6.55167 22.995 7.84961 12.6004 +635 2 7.14328 16.1838 7.27089 -9.73558 -8.55589 0.364412 +636 2 7.21237 16.006 5.79102 -10.9792 5.43097 -10.3878 +637 1 6.445 13.1807 5.57797 -3.32019 -20.8794 2.06608 +638 2 6.7301 13.9465 6.07331 -1.80129 7.88671 5.96843 +639 2 6.09943 12.5433 6.22286 1.13913 6.90777 -2.85329 +640 1 16.8242 12.5629 9.83758 3.36613 -21.9924 0.476486 +641 2 16.9985 11.8651 9.16533 -5.29916 18.5903 6.02329 +642 2 16.5644 13.3844 9.42716 1.61266 3.35571 -10.8679 +643 1 6.03738 2.95058 2.86354 -7.51536 -24.4327 -2.00067 +644 2 6.40977 3.757 2.57075 14.9417 32.1903 -3.64532 +645 2 5.57703 2.61747 2.09059 -4.23441 -8.07329 -3.19257 +646 1 10.9114 3.33767 3.30112 3.4906 -2.16377 5.30702 +647 2 10.297 4.02722 3.58926 -1.61521 -6.66566 -5.52383 +648 2 10.5127 2.84524 2.57795 -5.77666 1.81375 -3.43243 +ITEM: TIMESTEP +10 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.68194 7.08301 17.95 -9.31723 -4.61569 5.17534 +2 2 7.78696 6.81626 18.2438 14.604 4.05464 -8.83536 +3 2 8.80373 6.759 17.0506 -2.23465 -3.10488 4.80291 +4 1 18.5422 8.2512 6.84005 -1.85374 20.2636 49.1182 +5 2 0.133718 7.9438 5.98823 13.4692 -17.0673 -32.1853 +6 2 0.402402 7.78616 7.5434 -4.29735 0.835788 -17.7519 +7 1 8.38516 18.5522 6.81414 18.1861 9.65042 -3.37417 +8 2 9.3349 0.126592 6.72298 -16.1755 -3.42506 1.43069 +9 2 7.92248 0.594936 6.31239 0.819355 -0.881225 3.09059 +10 1 6.59178 1.84314 11.71 32.0023 -4.98621 -11.2566 +11 2 5.89352 2.36713 12.0513 -24.1224 14.8358 13.0259 +12 2 6.19214 1.0378 11.3953 -8.69892 -12.638 -2.90229 +13 1 7.13386 5.75674 2.33026 -14.5408 0.616599 17.9391 +14 2 6.48306 6.1089 3.01881 22.5383 -2.3727 -34.6055 +15 2 7.09544 6.2305 1.47237 -10.8297 -1.47351 21.389 +16 1 16.2171 10.1491 16.1328 -28.1801 3.24526 14.6911 +17 2 17.0032 10.2274 15.6211 19.8027 8.68317 -10.1896 +18 2 15.8342 11.0337 16.2804 9.6716 -6.93987 -4.62354 +19 1 10.6069 15.0266 2.30703 -4.98248 -17.7421 -7.27467 +20 2 10.5595 14.4209 3.0573 0.524935 2.03122 3.93242 +21 2 11.0455 15.8043 2.63229 7.74565 12.2645 5.86516 +22 1 17.1614 8.24714 10.3877 8.07926 1.42828 6.48104 +23 2 16.5623 8.78009 10.9215 0.0316367 4.64377 2.31684 +24 2 17.9785 8.76022 10.2824 -6.97801 -4.40732 0.702868 +25 1 14.8935 15.8724 16.3278 20.2214 -7.01151 6.5945 +26 2 14.0152 16.2142 16.2283 -22.9266 5.478 3.03945 +27 2 14.9126 15.3591 17.1528 -4.85523 2.97165 -4.07838 +28 1 12.1655 13.3835 0.413391 7.36911 -14.3954 12.824 +29 2 12.1103 13.7323 18.1651 -6.85057 6.78658 -3.29346 +30 2 11.6807 13.9152 1.05851 -4.03153 8.23708 -7.75902 +31 1 9.27599 5.36662 4.05276 -29.4571 7.127 11.0843 +32 2 8.67176 5.26931 4.85064 22.4619 1.60875 -30.6294 +33 2 8.67539 5.53054 3.28716 9.26602 -4.36827 15.8404 +34 1 1.82909 4.27439 11.6483 -10.3032 26.7578 -2.81239 +35 2 1.73625 5.21877 11.9337 1.99226 -22.9368 -8.90994 +36 2 2.3645 3.83767 12.2983 6.89168 -8.93952 11.7704 +37 1 1.96701 6.83625 8.36791 0.700563 -10.6105 -3.76521 +38 2 2.46094 7.16371 9.10974 5.61647 13.7513 9.96296 +39 2 1.91553 5.8986 8.57777 -2.9792 -4.95164 -6.48224 +40 1 5.40472 4.39468 7.93775 -13.5219 -10.4794 -16.6571 +41 2 5.47247 3.43369 7.82443 4.19114 6.69916 9.09153 +42 2 4.75726 4.62849 7.24994 8.09624 5.59982 9.8174 +43 1 3.2394 2.92305 17.5474 -0.484589 33.1528 15.1222 +44 2 3.93082 3.31406 16.9898 -0.722116 -4.79924 0.441987 +45 2 2.93778 3.68549 18.1255 3.8058 -28.2307 -17.5498 +46 1 7.46921 5.27133 6.11017 -1.04832 -15.5011 48.3459 +47 2 7.90561 5.59719 6.92877 -0.90713 11.0324 -30.0179 +48 2 6.96076 4.54233 6.5205 0.0145083 12.7024 -20.8234 +49 1 9.7753 7.02229 11.9825 10.38 0.905424 28.7819 +50 2 10.3185 6.36588 11.5577 3.53671 -5.58238 -7.94156 +51 2 9.14507 7.32646 11.347 -14.6838 3.32198 -19.6076 +52 1 14.1071 3.54759 8.03608 -23.8038 4.02857 -21.7378 +53 2 13.5341 4.25359 7.68722 9.9361 -9.73972 0.838395 +54 2 14.4214 3.88758 8.85457 11.6 9.53944 21.926 +55 1 4.79933 17.2591 4.02624 -13.379 0.496236 -8.73431 +56 2 5.57386 17.851 4.10922 -16.5825 -9.69995 -7.24814 +57 2 4.20396 17.5018 3.27728 17.9024 3.63898 12.5287 +58 1 16.5033 16.6227 10.0525 8.55043 -2.52252 -17.4646 +59 2 16.0579 16.4137 10.8501 -12.2091 1.77219 28.6058 +60 2 15.9447 16.1927 9.39741 3.82195 1.69594 -5.2917 +61 1 1.95551 4.92482 0.485806 10.2127 4.96395 -0.662752 +62 2 2.54163 5.27617 1.19707 -10.7364 -3.48306 -18.9921 +63 2 1.87778 5.63364 18.4632 -0.0680824 -4.88148 10.5435 +64 1 11.8064 13.3616 16.2803 -11.2011 -32.854 -16.2783 +65 2 11.3068 12.5375 16.4476 0.201944 14.5536 10.5803 +66 2 12.2047 13.1237 15.424 4.38621 16.2025 8.43328 +67 1 10.1065 11.0626 16.9483 14.8798 -23.3813 0.89342 +68 2 10.5718 10.2022 17.1278 -15.1514 23.106 -6.44625 +69 2 9.22125 10.8281 16.6474 0.614925 -0.65596 2.44857 +70 1 11.7253 17.5378 13.4688 -9.94093 -22.0621 2.41868 +71 2 12.2582 16.9669 12.8891 0.443382 11.1567 2.15207 +72 2 12.0419 18.4322 13.3705 7.56806 8.72697 -4.32807 +73 1 6.34321 9.31538 12.2256 -11.115 -24.1278 -16.4431 +74 2 6.95505 8.9709 11.5438 -2.74015 10.4344 10.5225 +75 2 6.7633 9.99127 12.7388 17.4243 13.1424 4.46627 +76 1 16.2194 12.7233 2.70094 -4.61478 -5.953 2.95318 +77 2 17.0002 13.1906 2.44934 22.4693 3.83429 -6.00104 +78 2 15.5655 13.415 2.69545 -17.2672 7.42791 2.42646 +79 1 0.634553 12.563 5.85853 -28.5577 11.9856 -12.6208 +80 2 0.914444 12.5082 4.92832 1.43228 -1.32003 11.8657 +81 2 18.3286 12.8558 5.76638 29.2028 -10.3468 5.65715 +82 1 5.19236 16.3841 18.4962 26.3246 -0.931967 -7.14386 +83 2 5.89246 15.8922 18.0344 -14.3156 -2.38899 -1.49205 +84 2 5.72254 16.912 0.454606 -10.9177 5.22319 5.94171 +85 1 0.515157 7.6307 4.06432 40.0561 19.3507 -22.9165 +86 2 18.554 8.04388 3.41083 11.6748 -7.97607 10.9949 +87 2 1.4672 7.83805 3.73432 -48.6916 -7.92141 18.8197 +88 1 3.14333 8.89821 6.52388 -38.7347 7.47588 -5.16066 +89 2 3.55606 8.61579 7.33755 0.264066 -1.79724 4.80444 +90 2 2.15121 8.92424 6.67318 38.4004 -3.38228 -2.38687 +91 1 7.3156 10.3041 16.1747 -22.5262 4.44621 22.8692 +92 2 6.53394 10.4783 15.6406 9.03524 -0.350523 -4.2891 +93 2 6.93671 10.3234 17.0875 14.5541 -1.9474 -13.7178 +94 1 11.1094 1.06061 5.00017 -8.33223 -1.63593 -20.1003 +95 2 11.1653 1.90766 4.53999 7.02718 4.91961 9.72987 +96 2 10.7116 0.517103 4.29895 3.46448 -7.62041 12.1963 +97 1 4.44086 2.70257 13.2121 -8.76198 -6.25056 -12.8305 +98 2 4.61839 3.20254 14.0253 0.411253 -15.6801 0.294236 +99 2 4.37598 1.71769 13.3483 2.92355 28.3656 12.0639 +100 1 8.41481 10.0299 1.78755 2.58083 -12.9704 20.4417 +101 2 8.40154 10.6596 2.53141 -0.930044 -1.16348 -6.83089 +102 2 8.61337 9.15635 2.20556 -3.35942 21.7495 -11.7521 +103 1 10.5245 1.75336 15.553 -8.62776 -1.95945 -5.61675 +104 2 11.4377 1.70086 15.8172 12.2485 -3.82632 7.39579 +105 2 10.5516 1.84495 14.595 -9.16331 1.82149 -1.12185 +106 1 2.77042 12.9421 7.75317 -7.76237 -6.33315 7.0975 +107 2 3.33238 13.5624 7.27685 -2.67968 -0.352894 -3.41328 +108 2 2.03777 12.7029 7.16368 7.79305 2.46945 -1.53229 +109 1 3.64399 11.6862 5.32015 -16.8384 -12.8234 -6.75612 +110 2 3.34983 11.0669 6.0167 8.99611 10.2661 -11.4747 +111 2 2.85416 11.8487 4.76712 13.6242 -0.0526402 5.20338 +112 1 6.87773 14.4784 16.8504 -8.96924 2.55968 -2.39612 +113 2 7.58262 13.8601 16.6681 3.90388 -1.06505 3.99858 +114 2 6.56163 14.7581 15.9821 -2.66358 -1.99085 3.97159 +115 1 14.1744 14.5416 3.41044 10.3942 -0.651763 -8.74467 +116 2 13.655 15.3132 3.20132 -4.79611 11.1016 -3.67227 +117 2 13.7666 14.1672 4.18264 -6.53868 -10.5118 9.50782 +118 1 8.26761 18.1769 16.0723 60.4333 -9.62543 6.95109 +119 2 8.90915 17.473 16.3173 -32.2452 -3.35667 -3.16806 +120 2 8.92378 0.250762 16.016 -23.6515 10.2222 -7.97846 +121 1 4.73314 1.61844 4.90498 10.4838 29.1168 -20.5116 +122 2 3.92346 2.13642 5.08344 11.5633 -7.75976 -5.77828 +123 2 5.26159 2.15735 4.23518 -22.3286 -21.1319 29.8735 +124 1 15.1246 12.8394 16.4387 17.4381 -4.51065 31.9511 +125 2 14.6778 12.9897 17.2989 -1.10989 -1.43715 -21.8055 +126 2 14.5277 12.6911 15.7205 -25.4533 -1.78625 -11.0751 +127 1 15.7863 18.3852 16.7922 25.908 13.3822 31.678 +128 2 16.4574 18.6243 17.5189 -32.4234 -15.7026 -31.1655 +129 2 15.6278 17.4293 16.8067 2.01305 5.51074 5.25351 +130 1 1.13886 1.13555 16.5514 1.07915 19.6556 20.6288 +131 2 1.93696 1.57732 16.8903 -4.88731 -5.90564 -11.4186 +132 2 0.480719 1.50241 17.171 6.36092 -10.7053 -11.3623 +133 1 18.0845 4.58532 15.87 11.914 -13.2929 -3.66508 +134 2 18.5793 3.94883 15.3177 -8.66069 11.808 8.70591 +135 2 18.5822 4.70936 16.6848 -0.518448 -1.56194 -3.55701 +136 1 12.2302 16.9486 16.128 -37.9176 -11.5423 26.3029 +137 2 11.3914 16.5899 16.5469 36.4287 7.40626 -6.62059 +138 2 11.916 17.193 15.2634 5.93841 3.5336 -18.1806 +139 1 15.8788 2.54988 17.9721 5.087 5.67773 0.124923 +140 2 15.7549 3.4391 18.3687 -1.45045 -15.8437 -11.8457 +141 2 15.6801 2.58174 17.0093 2.38633 7.36977 18.7833 +142 1 6.70786 13.8001 10.254 -2.60372 -2.62943 9.53833 +143 2 6.60649 13.5148 11.1732 2.18143 10.2669 -0.00882184 +144 2 6.57676 12.9909 9.76432 1.5038 -4.69959 -12.8892 +145 1 10.141 18.2121 2.80409 9.87418 27.4677 -18.8777 +146 2 10.2555 0.291999 2.14056 -0.137226 -16.5556 14.9505 +147 2 9.2689 17.8819 2.61553 -12.127 -4.1331 -0.131977 +148 1 2.97228 17.7542 6.06181 -6.28377 0.301135 37.0401 +149 2 2.07671 17.601 5.72694 10.6784 2.25774 -14.0772 +150 2 3.63482 17.801 5.37776 -0.270923 -2.52512 -18.6151 +151 1 12.5659 17.001 7.96656 -23.415 -18.3905 24.197 +152 2 11.9071 16.2804 7.97312 11.7411 4.46809 -11.7089 +153 2 12.3405 17.4671 8.78984 12.2149 7.72109 -10.0441 +154 1 14.887 15.2779 8.2893 -14.8827 1.47652 2.73183 +155 2 14.0296 15.7117 8.25541 -5.1427 0.792443 13.0916 +156 2 15.1979 15.4906 7.42354 24.2513 -3.00083 -20.068 +157 1 17.5454 18.3111 0.374663 -13.7707 -4.14946 -2.00055 +158 2 18.2555 17.754 0.11924 20.0055 -25.3354 -15.9225 +159 2 18.0059 0.295965 0.896687 2.592 26.2966 16.2474 +160 1 0.909555 10.373 1.4127 -25.0541 -38.6286 23.1399 +161 2 0.0989843 9.87796 1.71715 28.402 10.794 -7.01331 +162 2 0.540787 11.0804 0.922273 -7.26144 30.0328 -22.846 +163 1 1.56438 12.1819 3.32547 9.10171 15.3717 9.49092 +164 2 1.376 11.5384 2.66679 -5.32309 -27.3061 -8.25977 +165 2 1.61002 12.9703 2.79202 3.36268 15.5511 3.76031 +166 1 0.549815 17.2556 4.8751 10.3167 15.4421 -19.2536 +167 2 -0.00199658 17.9163 5.26632 -10.5855 22.2192 -2.30371 +168 2 0.434878 16.519 5.43169 0.723696 -37.6018 20.4622 +169 1 1.10394 1.00198 9.3932 22.7427 9.86492 -7.57605 +170 2 1.42144 0.685439 10.2466 -8.09769 -6.36772 6.76546 +171 2 0.213433 0.697197 9.27667 -15.9263 -9.88137 4.21803 +172 1 16.7947 2.33275 13.2864 3.73194 4.84267 -27.3174 +173 2 17.0439 2.54012 12.3481 -6.98409 -4.39606 26.1758 +174 2 16.4729 1.42155 13.294 0.162444 -0.657512 2.21945 +175 1 2.4659 15.8297 12.1956 27.3811 -11.2673 13.1923 +176 2 2.9226 15.5311 13.0144 -9.82996 7.11615 -19.573 +177 2 2.93231 15.4201 11.4444 -5.86947 6.23921 4.54204 +178 1 16.4361 15.5441 5.94616 -3.08145 19.3328 -8.8947 +179 2 17.3593 15.4783 6.2724 -11.5576 7.7283 -8.52746 +180 2 16.3183 16.2893 5.29043 11.1937 -18.2696 22.1006 +181 1 5.84475 5.01999 11.7951 -3.08481 -3.45829 -4.75382 +182 2 5.52388 5.87345 12.0737 0.2772 11.9484 7.56792 +183 2 5.11411 4.43946 12.0133 1.47645 -8.9756 -0.689037 +184 1 15.224 4.86392 0.726277 -25.4938 -12.7349 25.4219 +185 2 14.7355 4.51715 1.53205 23.492 12.9767 -22.6649 +186 2 14.5328 5.02763 18.7193 1.17802 2.78752 1.94947 +187 1 16.3449 16.2967 2.11437 10.483 7.37611 -22.6614 +188 2 15.9997 16.7982 2.83675 -10.4405 6.50893 22.1211 +189 2 16.6677 16.9984 1.52582 -1.93062 -9.0043 0.169523 +190 1 0.302094 4.87802 3.79689 -13.2533 37.9479 3.00012 +191 2 0.313912 5.8808 3.95538 6.86913 -44.9842 -7.10747 +192 2 1.1462 4.49233 4.0346 3.71094 3.5442 4.02727 +193 1 2.9221 14.9895 15.0397 8.46471 -6.33736 14.5665 +194 2 3.00495 14.6058 15.9566 -9.31495 16.4585 -22.1508 +195 2 2.45729 15.8402 15.0938 1.85721 -3.29548 9.95349 +196 1 1.12 14.5717 9.56227 17.989 48.8934 -19.0037 +197 2 2.07414 14.5222 9.32346 -20.956 -13.4859 7.84449 +198 2 0.791626 13.7731 9.9282 4.87275 -29.8773 11.3577 +199 1 13.6624 16.6636 11.5457 -10.5327 9.77879 -22.0557 +200 2 13.3286 17.4311 11.0186 6.18992 -14.9435 17.5347 +201 2 13.3805 15.8992 11.021 -2.34987 0.215756 7.80532 +202 1 4.73359 1.47857 0.718618 -25.3973 -6.06392 2.87887 +203 2 4.17185 2.00661 0.129453 7.95287 0.81937 2.61464 +204 2 4.09095 0.858388 1.12753 14.212 5.94905 -1.43657 +205 1 1.42476 18.4735 11.9056 -5.99404 19.5083 -8.93412 +206 2 1.23513 0.382953 12.6723 -0.378912 0.915416 0.341246 +207 2 1.89505 17.7259 12.2433 7.21066 -16.1249 4.04173 +208 1 11.5448 10.106 4.11346 25.2596 15.8213 -25.5125 +209 2 11.5283 10.5663 3.22641 -2.70186 -14.3529 26.6987 +210 2 12.5027 10.081 4.37886 -27.2068 -0.404219 -8.52489 +211 1 8.37485 12.1748 3.75184 -11.9448 24.9759 46.3975 +212 2 9.17743 12.5878 4.11803 1.10724 -8.54244 -18.9118 +213 2 7.75197 12.4339 4.49102 7.61965 -18.0915 -33.0697 +214 1 14.3244 4.03247 3.293 11.3964 4.48411 20.4985 +215 2 14.943 4.18459 4.05162 -10.8147 -3.75721 -20.4981 +216 2 13.4909 4.45368 3.55282 4.29688 -1.92648 -2.70238 +217 1 5.58313 1.77339 7.50694 -37.3093 -46.6507 29.7736 +218 2 4.97145 1.12464 8.0478 36.2685 39.0776 -31.448 +219 2 5.37556 1.59155 6.57949 1.79923 3.69516 -0.386563 +220 1 17.9058 1.11523 4.88403 9.14173 18.8744 -7.73144 +221 2 18.4454 1.57607 4.20954 -6.0377 -15.1011 6.62684 +222 2 17.7347 1.81107 5.53023 -2.74058 -7.94095 2.09707 +223 1 6.8279 9.39776 4.48823 3.62694 -0.974221 -6.28613 +224 2 6.84568 9.51125 5.43283 -7.5389 4.30482 14.2207 +225 2 7.717 9.07508 4.31798 2.90721 -0.358573 -8.96695 +226 1 2.70207 14.9601 1.96467 9.48597 -9.94138 -22.1344 +227 2 3.35633 14.7518 2.62888 0.238693 -0.206349 10.2383 +228 2 3.16249 14.7444 1.12616 -13.7934 7.99556 12.9651 +229 1 17.2754 12.8959 13.1352 7.09139 -37.5845 3.69594 +230 2 16.3537 13.1102 13.3148 3.80173 19.6017 -1.81888 +231 2 17.838 13.6507 12.9698 -8.26303 20.1956 -1.14982 +232 1 15.0171 10.5799 1.38486 -27.8548 -28.8799 -20.6854 +233 2 15.5438 11.2121 1.82149 21.7425 28.5078 17.6295 +234 2 14.2994 11.069 0.967203 2.72678 -1.55793 4.42244 +235 1 5.71388 6.94387 4.52744 5.06868 -23.5408 12.0019 +236 2 5.87421 7.87915 4.41499 3.45829 8.88765 -0.888191 +237 2 6.40286 6.63416 5.14703 -8.303 0.627238 -7.76707 +238 1 8.10838 8.26645 10.1831 -2.58942 7.80898 11.2224 +239 2 8.62669 8.8788 9.66253 10.4484 9.83111 7.1505 +240 2 7.63286 7.80673 9.50478 -12.057 -13.4779 -6.03182 +241 1 13.5281 18.2914 5.80176 -22.4215 -1.8227 14.6872 +242 2 12.749 0.212336 5.63336 9.50875 -1.85743 -1.68773 +243 2 13.2346 17.7232 6.55015 8.07385 12.1374 -16.5266 +244 1 0.320637 2.55746 0.113707 -24.4854 52.0087 1.52013 +245 2 18.0083 2.70852 18.6241 7.28296 -16.9077 1.12853 +246 2 0.626424 3.4996 0.197011 8.79214 -31.4205 1.87945 +247 1 12.6453 10.9632 9.76861 -25.4211 42.834 -14.9231 +248 2 11.6492 10.8795 9.70071 37.3368 -7.50244 3.90461 +249 2 13.0228 10.1402 10.0352 -3.08107 -28.1376 6.91694 +250 1 0.78452 12.2807 11.0864 19.7349 -6.9692 -1.93691 +251 2 18.4749 12.3028 11.1225 -11.4863 3.49833 6.83674 +252 2 1.15231 12.659 11.9029 -10.6903 -3.95248 -3.68276 +253 1 5.04293 7.22507 13.482 3.09598 5.99749 -4.73795 +254 2 5.58886 7.93262 13.132 -0.232718 7.71962 -10.0141 +255 2 5.52798 7.00144 14.2755 -0.932575 -7.50807 9.86229 +256 1 1.28071 6.97469 11.8373 -31.3117 -37.3004 -11.5925 +257 2 0.492113 7.17802 11.3051 9.94401 -3.39318 6.90536 +258 2 1.685 7.80152 11.9673 18.2328 34.095 8.03536 +259 1 15.4541 9.47192 12.3133 5.85738 22.5951 5.06509 +260 2 15.5175 10.4638 12.3742 -4.62374 -31.0112 4.63394 +261 2 15.4968 9.06746 13.1992 -1.35817 12.6181 -10.5463 +262 1 16.6442 12.9519 5.45538 -21.4717 15.277 -31.3145 +263 2 16.3435 13.8787 5.41602 10.8128 -9.57177 19.5795 +264 2 16.428 12.7198 4.52965 10.5011 -15.0883 17.3079 +265 1 6.17539 10.0558 0.19339 -10.2788 -9.80575 -26.1597 +266 2 5.38875 10.4515 0.589333 6.07089 -1.52504 2.9393 +267 2 6.86188 10.0925 0.84877 11.0601 2.17112 10.8149 +268 1 12.366 6.05676 4.0416 -22.1854 -19.7968 12.9024 +269 2 12.3704 6.78834 3.44644 3.0333 22.1434 -14.5586 +270 2 11.4296 5.77117 4.03801 16.8285 0.174707 3.6691 +271 1 0.132536 12.8255 0.204274 -0.526736 3.63462 -3.55478 +272 2 -0.0162245 13.5547 0.824079 2.12041 -2.82991 -1.20796 +273 2 18.2367 13.045 18.0704 5.31007 -1.26571 4.82883 +274 1 3.83823 18.58 8.61434 -10.0824 -4.97514 -18.4016 +275 2 3.52069 18.2861 7.74382 9.30441 -4.40092 2.94392 +276 2 3.03757 0.306881 8.974 -6.88025 7.19874 10.2509 +277 1 7.39362 17.2775 4.45212 12.7302 8.58303 13.7229 +278 2 7.99666 17.968 4.81801 -14.6435 -15.1886 -20.2263 +279 2 7.36047 17.3088 3.48385 6.79225 7.50625 8.12072 +280 1 9.21958 17.0373 12.2266 15.7968 3.09867 9.11932 +281 2 9.35553 16.2013 11.7334 2.65662 13.4997 9.89778 +282 2 10.0046 17.242 12.8046 -16.9951 -13.4125 -19.4407 +283 1 13.3157 13.0082 7.94027 -17.3901 -31.9016 7.67948 +284 2 13.1929 12.2449 8.54147 -2.27359 6.97807 -8.06923 +285 2 14.1396 13.3907 8.1966 15.275 17.864 3.60781 +286 1 14.9833 2.94943 15.3513 6.95235 -3.03472 -25.2367 +287 2 14.3042 2.39498 14.9448 0.627233 -0.993788 8.39197 +288 2 15.6656 2.99789 14.6444 -10.442 2.78752 17.6131 +289 1 9.85751 15.5027 17.0048 6.47201 6.54967 -7.92386 +290 2 10.2825 14.6779 16.7304 0.0104739 2.25127 2.62159 +291 2 9.29444 15.3215 17.7618 -3.54568 -3.88732 3.90928 +292 1 11.2881 8.2507 16.5469 4.08161 11.4658 1.26949 +293 2 10.784 7.71518 15.9432 -10.4144 -1.78397 -10.2593 +294 2 11.7122 7.60386 17.1014 6.56418 -3.83522 10.5232 +295 1 3.78473 18.1936 16.723 -4.68023 16.7202 -12.0174 +296 2 4.25527 17.5912 17.2966 7.9068 -1.91441 12.6846 +297 2 3.78787 0.451609 17.087 5.31404 -15.3334 2.54941 +298 1 2.1979 4.10843 8.95106 26.9406 -12.5237 33.2314 +299 2 3.04044 3.62982 8.81286 -17.1971 13.1508 -10.8815 +300 2 2.16124 4.09638 9.93984 -10.9226 5.8942 -24.7105 +301 1 9.90906 10.3512 9.74092 -24.4032 35.3078 2.18412 +302 2 9.42476 11.1784 9.45919 17.314 -27.1904 0.11143 +303 2 9.91744 10.4013 10.7102 5.12409 -5.92526 -7.2544 +304 1 9.73754 0.812356 10.8589 -9.45704 -2.93658 -4.01088 +305 2 9.44076 18.5949 11.1517 4.40065 -9.39685 13.0528 +306 2 9.08713 0.996724 10.1835 0.761981 14.6946 -8.69624 +307 1 9.19301 15.2105 10.2107 -22.2036 -10.0383 -7.82623 +308 2 8.98025 16.0713 9.80369 1.46967 -14.8527 4.99479 +309 2 8.36662 14.6679 10.1029 23.0402 13.9843 6.10558 +310 1 0.991303 9.28993 10.3284 48.5242 0.758788 -7.3086 +311 2 1.23965 10.2015 10.4879 -14.9681 11.3684 1.41472 +312 2 1.89881 8.9146 10.1688 -36.1698 0.796544 3.16897 +313 1 16.8183 4.88742 8.19443 14.5542 -10.1877 33.2312 +314 2 16.1728 5.34475 8.77937 11.7085 -6.30946 -17.3069 +315 2 17.4003 4.3619 8.8005 -18.9368 13.5764 -18.1776 +316 1 14.6428 14.6932 0.395223 -8.43601 -1.47433 8.87339 +317 2 15.0319 15.2579 1.0921 -3.12605 -9.09789 -8.18687 +318 2 13.8519 14.2576 0.787234 16.4944 11.1317 -8.84191 +319 1 3.51972 11.0527 9.63241 -0.0258339 11.398 -8.76826 +320 2 3.50143 11.4368 10.5206 2.13389 -0.105265 -4.21661 +321 2 3.1724 11.7459 9.02999 3.72912 -11.0816 8.2725 +322 1 11.0404 10.8634 1.27208 6.70694 17.4362 -9.49329 +323 2 11.1727 11.6824 0.735781 1.31404 -20.4369 14.6488 +324 2 10.1116 10.6362 1.15363 0.362803 -1.95542 1.92755 +325 1 13.2201 7.06705 12.8916 -20.9652 2.88797 -6.38338 +326 2 14.1438 6.85164 12.9216 15.9393 -3.58362 1.12932 +327 2 12.7477 6.22232 12.897 3.28641 3.49729 -0.863357 +328 1 9.62872 1.89177 0.948251 6.96093 0.24991 16.0649 +329 2 8.76715 2.00519 0.577625 -19.1552 -2.18542 -3.65809 +330 2 10.1854 1.76875 0.19003 12.4655 1.79214 -8.44775 +331 1 10.594 13.5319 4.7375 16.0423 -1.41644 13.6035 +332 2 11.415 13.0379 4.93682 -11.8157 3.93147 -13.4525 +333 2 10.5255 14.1008 5.52348 -3.94863 -4.31219 -11.1546 +334 1 14.2685 1.70153 10.8945 -3.08057 3.85383 7.15216 +335 2 15.0552 1.23258 10.5836 3.50278 10.8149 -1.53255 +336 2 14.4104 2.66429 10.8947 7.37053 -8.35752 -2.77651 +337 1 14.6611 12.4198 11.7249 1.4364 -26.5965 -56.3444 +338 2 15.4897 12.4837 11.202 -5.7241 6.85295 22.6084 +339 2 14.0924 11.9909 11.0313 1.01548 12.4899 31.9742 +340 1 8.24953 5.08668 9.79072 -30.3058 0.287699 22.814 +341 2 7.41708 5.03925 10.3073 16.545 17.0491 -5.32162 +342 2 8.22462 4.2143 9.42755 11.9131 -18.3304 -16.4659 +343 1 1.59402 16.8187 18.3253 -6.20255 31.6963 -6.78121 +344 2 1.91227 17.2067 17.482 -4.95179 -10.2412 13.7563 +345 2 1.83336 15.9037 18.3179 8.32765 -17.6711 -3.36436 +346 1 1.43897 17.2464 15.3358 29.6054 -7.17934 -6.21787 +347 2 1.36087 18.1379 15.637 5.97318 20.4573 7.89508 +348 2 0.556137 16.9475 15.3273 -33.612 -15.1267 -3.09538 +349 1 3.72895 5.57357 6.20543 -8.92972 12.8219 1.61975 +350 2 3.23079 6.21113 6.76482 10.0758 -7.74032 -14.0976 +351 2 4.28418 6.06511 5.5772 -4.67021 4.78615 6.0759 +352 1 12.3529 9.4251 14.1822 19.6727 -43.1834 10.5387 +353 2 12.884 8.61082 13.8993 -22.621 36.8155 4.19437 +354 2 12.0516 9.14148 15.0731 3.60544 11.6456 -14.396 +355 1 4.03531 15.2728 6.90881 24.4865 3.71204 -3.62934 +356 2 3.44033 16 6.68284 5.60112 1.73001 -3.29651 +357 2 4.96253 15.5542 6.68078 -28.8575 -4.96404 7.1648 +358 1 0.605953 8.56457 14.8638 -0.120582 -0.391313 3.99343 +359 2 0.501042 9.52227 15.005 5.35221 -7.46858 -4.68281 +360 2 1.25554 8.44629 14.1506 -6.09669 6.93914 6.70414 +361 1 12.9734 8.36578 10.3368 20.5003 -18.2509 -7.79226 +362 2 13.7393 7.86937 9.99522 -8.8873 10.1321 -9.444 +363 2 12.9708 8.03443 11.231 -10.3099 3.90117 14.6287 +364 1 15.2894 7.6332 3.49269 12.7581 18.2329 -13.143 +365 2 14.5338 7.17315 3.08677 6.1918 -0.800492 21.6775 +366 2 15.5136 7.51531 4.43453 -15.4019 -14.7068 -6.3771 +367 1 17.3212 6.64473 0.0316567 -27.1824 12.6283 -1.8657 +368 2 16.771 5.99448 0.499966 9.26154 0.672542 -4.32476 +369 2 16.64 7.24337 18.2783 17.9792 -11.5061 8.92142 +370 1 8.80668 6.92454 7.83918 -24.3908 -17.2325 7.20576 +371 2 9.68081 7.28212 7.80962 25.7376 5.86496 2.86911 +372 2 8.71775 6.37228 8.64787 6.10597 9.33115 -12.275 +373 1 12.3202 0.615137 1.17425 13.6931 -3.72396 -2.19539 +374 2 13.075 0.992886 1.63957 -0.40119 2.44364 5.09949 +375 2 12.7571 18.5667 0.666384 -10.9298 0.853201 -1.96514 +376 1 5.6785 15.1027 14.5126 8.23045 15.6484 -5.86338 +377 2 4.72039 15.1784 14.5966 0.299323 4.01186 0.94539 +378 2 6.04535 15.9236 14.1081 -12.4379 -14.8055 10.7649 +379 1 3.83406 6.52943 1.68496 -5.12703 10.9404 0.999964 +380 2 3.44824 7.31709 1.2662 3.88585 -11.3877 -2.55221 +381 2 3.84338 6.82178 2.59771 5.33619 -6.06857 7.79227 +382 1 3.88904 11.6132 12.2401 8.95627 -8.79814 -2.40389 +383 2 4.75841 12.0277 12.3683 -7.0992 0.0294616 4.018 +384 2 3.233 12.1226 12.7151 -2.84239 9.6423 6.84851 +385 1 5.44987 3.87776 15.8711 9.04603 51.7105 12.2927 +386 2 5.99752 3.20763 15.4917 15.5436 -17.9801 -7.19396 +387 2 6.04703 4.69158 15.9698 -28.7283 -34.9666 -5.01916 +388 1 14.4605 10.3225 4.39641 11.4537 -30.5762 -31.9722 +389 2 14.8306 9.83502 5.14205 -5.39586 2.29688 2.9797 +390 2 14.6901 9.75629 3.58792 -12.4512 26.4694 34.1579 +391 1 7.94485 17.2962 9.23406 -29.3852 32.3044 -4.90329 +392 2 7.20157 17.582 9.8013 11.6936 -12.8295 -3.21694 +393 2 7.93254 17.9646 8.52624 8.85814 -10.3239 0.926379 +394 1 4.49873 14.4249 3.9575 27.1774 17.1098 41.9883 +395 2 4.83669 15.3326 4.20793 -17.2661 -25.1881 -14.2087 +396 2 4.80599 13.8528 4.71739 -13.53 13.4591 -29.2523 +397 1 14.3284 7.3854 15.7629 16.5671 6.07561 9.97379 +398 2 15.2454 7.23106 15.4511 -19.609 3.15959 8.32151 +399 2 14.4426 7.80786 16.6389 -4.4507 -8.27801 -15.1382 +400 1 2.87403 18.2247 1.90389 13.9577 30.3231 32.1513 +401 2 2.546 17.6397 1.25326 -17.0615 -24.6646 -23.5795 +402 2 2.12038 18.5502 2.43008 9.19244 -2.23706 -9.85686 +403 1 7.96361 1.60549 4.53489 27.0952 14.1367 0.307488 +404 2 7.49638 1.9472 3.77739 -15.4877 0.180801 -4.55719 +405 2 8.8215 2.06687 4.46869 -11.5471 -13.5362 7.94734 +406 1 2.67177 14.1298 17.7578 -32.0965 -17.6674 6.84649 +407 2 1.82063 13.6639 17.9969 26.9839 12.0838 -7.18622 +408 2 3.38659 13.5743 18.1098 -5.52669 6.70603 -3.66321 +409 1 0.723551 1.68725 13.8621 17.7332 3.27009 -2.43746 +410 2 0.829271 1.51069 14.7908 7.98206 -4.95309 12.0999 +411 2 18.44 1.84118 13.7764 -20.4783 4.25661 -8.09669 +412 1 4.55406 18.6 13.9636 17.2604 -7.63309 -9.35161 +413 2 5.43897 18.1924 13.8214 -18.4623 11.1021 3.79828 +414 2 4.32329 18.399 14.8757 -4.15164 0.0521115 2.41255 +415 1 7.10455 0.474046 18.3679 -11.2359 27.2348 29.1061 +416 2 7.12016 0.115813 17.4965 -1.63433 -6.1865 -23.0052 +417 2 6.24271 0.910062 18.5515 12.5771 -12.8936 -7.91243 +418 1 16.1005 18.44 14.1333 -36.4501 -27.5791 -6.57953 +419 2 15.3829 17.8174 13.8465 25.6281 20.8019 -1.7164 +420 2 15.9077 18.5395 15.0719 9.49834 8.44163 -0.14337 +421 1 10.1046 4.52059 16.2893 -46.9792 2.1543 -16.8809 +422 2 11.0012 4.49779 16.5541 31.7343 -4.51398 5.87687 +423 2 9.86248 3.65729 15.9089 12.0807 6.21086 8.83226 +424 1 15.8363 17.9271 4.41684 -16.1004 8.03032 22.5493 +425 2 16.5039 18.6299 4.52246 -8.60661 -6.24751 -1.3813 +426 2 15.0378 18.2098 4.9532 29.0614 -11.0784 -22.6438 +427 1 6.9284 17.3613 13.7353 43.359 11.4946 7.60179 +428 2 7.46858 17.7163 14.5015 -21.3841 -13.8198 -23.6549 +429 2 7.59514 17.216 13.0184 -16.6797 3.36376 18.1603 +430 1 13.2847 6.56451 6.73769 -14.228 -11.1924 -15.3605 +431 2 14.2169 6.67596 6.68467 27.6084 8.49537 10.422 +432 2 13.086 6.40899 5.80997 -14.9004 -1.60425 -0.509451 +433 1 7.67719 2.38409 9.18276 -12.7481 -9.95901 -21.449 +434 2 7.23781 2.34079 10.0234 -2.84678 0.492631 19.9336 +435 2 6.97018 2.11077 8.55354 21.5545 6.86467 6.74712 +436 1 15.1528 14.8764 13.6487 -19.1236 6.62595 6.09279 +437 2 14.9964 15.042 14.5941 6.3649 -1.885 -8.0702 +438 2 14.3208 15.1168 13.2045 14.5757 -4.46306 2.19701 +439 1 9.29857 8.33432 3.70772 10.6355 -8.13532 4.49802 +440 2 10.1502 8.81328 3.76286 -8.0776 -10.0517 2.73632 +441 2 9.46492 7.39019 3.89736 0.427871 14.9166 -2.52044 +442 1 17.6858 13.4785 16.4504 18.1421 12.8824 -2.9019 +443 2 16.7336 13.3749 16.3876 -0.564153 6.32044 -4.53985 +444 2 17.9415 14.3223 16.0098 -13.7235 -15.3212 6.57805 +445 1 5.04165 10.6569 2.59879 15.0811 -13.5005 18.1704 +446 2 5.79991 10.2916 3.10884 -13.8602 3.81488 -12.1379 +447 2 4.57944 11.1735 3.25148 -7.64374 9.33605 4.93504 +448 1 3.71156 8.35988 10.3223 2.69392 -10.4458 7.32 +449 2 3.86762 9.29314 10.1995 2.90356 12.3134 -9.75827 +450 2 3.79851 8.25131 11.2818 -4.19061 -2.88345 -8.87222 +451 1 16.1009 7.11278 6.31821 6.57165 -19.5926 -13.3215 +452 2 16.7556 7.67982 6.75754 -3.32154 -9.30994 -6.24555 +453 2 16.5222 6.22545 6.20359 -10.7974 20.4957 5.39095 +454 1 15.1877 7.01217 9.11633 -0.942582 31.3193 -31.4924 +455 2 16.0087 7.4094 9.45282 -9.93766 -6.26011 -0.320925 +456 2 15.0368 7.51069 8.25256 3.47491 -21.9129 34.3614 +457 1 6.44498 13.1525 12.9077 -4.11711 1.46333 8.37594 +458 2 7.24124 12.6683 13.1519 -1.65948 -2.61146 -1.33868 +459 2 6.29723 13.796 13.6274 -0.63037 -8.66373 -16.4588 +460 1 12.122 4.49686 13.0678 27.186 16.1548 19.2119 +461 2 12.2551 4.61131 14.0219 7.12074 5.87928 -4.56992 +462 2 11.3374 3.99971 13.0395 -36.5276 -21.5475 -13.6693 +463 1 11.3413 8.18743 7.85231 -9.00357 4.77407 0.37365 +464 2 12.0188 7.6639 7.39095 2.25052 4.68793 14.2505 +465 2 11.6381 8.44006 8.74837 5.13859 -10.097 -12.5363 +466 1 17.1781 10.7776 7.41775 8.98079 -10.5429 4.93206 +467 2 17.827 10.053 7.20793 -14.7505 26.0455 -2.01259 +468 2 17.1485 11.4724 6.73654 6.61625 -12.2683 -1.04931 +469 1 5.23072 18.1435 11.0535 -19.1878 -10.0323 -1.26774 +470 2 4.70405 18.0783 11.8789 8.35901 -0.713622 -15.9457 +471 2 4.65273 17.8196 10.3204 13.2116 10.9899 16.482 +472 1 7.5638 17.6255 1.82385 0.18941 -4.57957 5.58349 +473 2 7.78527 16.8134 1.38126 5.66428 -18.4097 -0.230917 +474 2 7.45334 18.2192 1.09148 -1.66074 15.0057 -4.75644 +475 1 1.8616 12.9257 13.6096 9.14642 8.79388 9.51824 +476 2 1.6025 12.3584 14.3568 1.58601 7.25854 -8.04733 +477 2 2.19519 13.7677 13.9951 -8.21693 -20.1216 -3.01678 +478 1 9.73071 6.79429 14.803 -9.96431 20.7294 -5.24946 +479 2 9.965 5.93538 15.1079 4.49059 -29.2435 15.7374 +480 2 10.0131 6.81015 13.8895 1.7202 7.35701 -8.16934 +481 1 15.2073 4.3815 10.7753 5.02149 -7.87008 -1.3136 +482 2 16.102 4.07091 10.8622 12.544 -14.2164 -8.54624 +483 2 15.2461 5.11302 11.375 -14.5847 15.9831 9.57625 +484 1 11.1932 6.12384 0.161263 5.03411 2.82645 3.69768 +485 2 11.3288 5.17786 0.364595 -11.2178 11.9329 -9.49937 +486 2 10.2678 6.33084 18.566 9.25768 -12.2342 6.14633 +487 1 0.186838 11.3278 15.1363 -29.5173 30.1692 -23.1318 +488 2 18.3705 11.8565 14.4078 15.8912 -24.6881 20.4884 +489 2 18.5399 11.8236 15.9183 6.48048 -3.45982 -2.85079 +490 1 7.07004 9.14522 7.26474 -13.1186 -12.9635 8.90657 +491 2 6.53932 8.3872 7.60207 7.2147 19.6305 -8.47997 +492 2 7.95552 8.78183 7.22801 5.51641 0.721385 -0.901037 +493 1 18.4462 15.4465 12.3531 0.397712 -4.42488 4.01328 +494 2 0.764911 15.5581 12.2944 -10.8471 -1.16552 -3.91149 +495 2 18.1036 15.6779 11.4829 2.90793 1.2817 1.1609 +496 1 16.5729 4.36464 5.24677 -25.0478 -7.96005 29.4563 +497 2 16.6771 3.95228 6.15287 5.89012 16.1194 -31.2199 +498 2 17.3789 4.38374 4.73556 17.0857 -2.87844 2.77648 +499 1 17.7776 3.07164 10.7152 20.2072 1.91324 7.6701 +500 2 0.0768882 3.1314 10.9751 -16.1773 7.43675 -1.86825 +501 2 17.7244 2.20926 10.3009 -7.90603 -5.17093 -4.6179 +502 1 12.3097 0.0632784 10.17 -5.23585 14.9609 -0.662134 +503 2 11.3669 0.329281 10.3192 28.4735 0.874848 -0.34084 +504 2 12.8997 0.858518 10.2668 -24.0851 -21.9241 -3.33166 +505 1 10.3626 9.82488 12.3121 10.8795 10.4681 17.7395 +506 2 11.1241 9.87716 12.9295 -11.9387 -4.40292 -9.54779 +507 2 10.179 8.8911 12.2253 1.1465 -9.5921 -0.185536 +508 1 0.479623 2.83009 7.02164 2.3472 21.5918 -9.19818 +509 2 0.779466 3.61946 7.51564 -3.03286 -18.4976 -0.625243 +510 2 0.704445 2.06385 7.54355 5.66126 -3.27927 9.79357 +511 1 0.467007 15.244 6.91284 -2.81724 -38.2268 -9.44322 +512 2 0.589986 15.6097 7.78713 1.11258 -6.7374 10.833 +513 2 0.615386 14.2454 7.00377 -3.57496 47.8567 -6.78063 +514 1 16.9531 7.01102 15.3314 25.0955 -6.26352 -3.35293 +515 2 17.7312 7.54015 15.1398 -4.24099 15.1997 -5.49373 +516 2 17.3882 6.19624 15.5982 -13.584 -8.29127 -0.013797 +517 1 9.00968 12.4205 8.1448 -47.4595 3.97518 -14.6445 +518 2 9.255 11.8265 7.44329 24.3825 -11.7648 -7.05727 +519 2 8.04408 12.5071 7.93332 27.0995 7.32888 21.0703 +520 1 1.26609 1.94093 3.05591 2.05426 9.79258 -12.831 +521 2 1.21698 2.59367 2.33971 -7.6512 -12.9321 3.35408 +522 2 1.90984 2.32941 3.65026 1.81811 -2.05605 5.16186 +523 1 4.13335 15.1162 9.63732 -3.37236 0.94273 -0.929026 +524 2 4.11982 15.1465 8.67375 -6.81504 5.04573 1.04836 +525 2 4.9784 14.712 9.81623 8.98269 -4.0071 9.77097 +526 1 7.18021 2.17978 14.5671 7.55504 9.68183 9.47496 +527 2 6.93575 1.71258 13.7681 -0.50379 0.233559 -6.02908 +528 2 7.66352 2.97784 14.2972 -3.4628 -8.48803 0.116771 +529 1 18.6085 14.7119 2.15295 17.2538 -25.5542 -3.98016 +530 2 0.854482 15.0949 2.23403 -8.04084 1.8593 -0.311551 +531 2 17.9464 15.3611 2.33256 -11.9957 20.7574 3.41759 +532 1 9.94838 2.78838 12.9451 -1.38176 -12.4025 -13.9087 +533 2 9.76343 2.19068 12.1969 8.49761 3.03822 8.73498 +534 2 9.19943 3.38599 12.9407 -2.82035 8.06337 4.45668 +535 1 2.81023 8.91387 13.015 -11.0947 -9.09099 -1.03322 +536 2 3.12702 9.79437 12.8576 7.30933 17.7942 -2.89213 +537 2 3.52626 8.44288 13.432 10.5553 -8.83156 6.15268 +538 1 3.22981 8.35572 3.63929 7.91603 12.3414 59.3292 +539 2 3.55022 9.08279 3.12704 6.39159 12.4302 -19.4578 +540 2 3.47038 8.64809 4.58003 -14.7797 -20.4427 -37.089 +541 1 5.63158 7.19787 8.5111 -16.5836 -10.0318 8.45115 +542 2 5.49703 6.26423 8.32413 12.2862 -3.4998 -5.25722 +543 2 4.92977 7.35667 9.15199 5.58983 12.4707 2.72685 +544 1 14.8806 1.27947 2.01044 -5.20911 -29.6221 -13.7523 +545 2 14.8531 1.98102 2.64457 3.54145 24.2946 3.1913 +546 2 15.2413 1.51873 1.14568 -0.321243 12.6895 5.96264 +547 1 8.23741 15.1928 0.849855 10.5438 9.56485 -11.8122 +548 2 9.03414 15.1092 1.40038 -9.07879 -4.36113 3.60062 +549 2 7.50349 14.6875 1.21874 4.98636 -2.78068 7.26539 +550 1 15.6325 1.34538 7.23629 -19.2726 -10.6819 -7.69516 +551 2 14.9548 0.715658 6.87861 16.0521 20.279 9.35294 +552 2 15.1584 2.15623 7.4957 0.78871 -9.00488 -4.70177 +553 1 4.90948 13.0908 18.526 11.7484 -4.19917 14.2638 +554 2 5.32661 13.1046 0.771936 -5.81675 2.26251 -17.1314 +555 2 5.47193 13.6353 17.9612 2.08739 -3.03703 1.40027 +556 1 15.3444 8.47528 18.1477 10.5782 11.2904 -17.9652 +557 2 15.7712 9.10441 17.5134 -10.1785 -13.1115 16.9911 +558 2 15.2549 8.94211 0.342082 0.277618 5.95495 -1.45242 +559 1 12.072 3.0348 18.3713 9.16845 -16.043 3.97866 +560 2 11.9997 2.53228 0.532204 -11.5106 10.3924 18.501 +561 2 12.5782 2.36842 17.9104 5.62845 7.32417 -26.0863 +562 1 13.2089 12.6783 5.18015 6.63876 -6.29032 2.85699 +563 2 13.7391 11.9795 4.78379 -2.73226 -0.00342211 -8.22979 +564 2 13.3831 12.5487 6.11225 -3.40081 8.86391 8.40941 +565 1 6.04915 7.04527 0.0350485 10.8742 -21.2203 -4.52865 +566 2 6.02805 7.99092 18.6226 -5.46576 23.9499 6.727 +567 2 5.33859 6.76219 0.618839 -5.51003 3.35157 1.33709 +568 1 17.7393 16.0214 15.0094 13.9302 -13.9422 41.059 +569 2 16.9573 16.5339 15.2303 -2.65419 1.12677 -17.6965 +570 2 17.9199 15.9264 14.0844 -11.8828 6.17072 -25.9912 +571 1 13.1897 1.00209 16.5482 9.0285 -11.9403 8.82412 +572 2 14.1531 0.926941 16.6936 -12.5978 2.36886 -2.70952 +573 2 12.8801 0.0805392 16.5939 -0.793518 8.62378 -3.88342 +574 1 11.1147 14.5676 7.20714 13.0879 22.2032 -16.1382 +575 2 10.392 14.3041 7.74555 -20.7251 -13.6554 17.189 +576 2 11.8256 13.9392 7.33494 4.5733 -4.90634 5.95678 +577 1 17.5119 8.63301 2.08454 0.0660302 9.5119 10.6671 +578 2 16.6736 8.51459 2.527 -7.33525 3.37542 8.64387 +579 2 17.5132 7.89769 1.49414 7.23803 -17.2019 -20.825 +580 1 12.3543 7.99739 2.01665 -2.5776 9.38468 -13.8973 +581 2 12.1955 8.87571 1.62365 2.26325 -8.37679 12.9533 +582 2 11.9634 7.39841 1.37453 -1.21895 -7.08079 -1.91625 +583 1 11.8862 14.6191 10.3431 -20.5633 -33.2885 -21.2052 +584 2 12.048 13.7971 9.8109 4.18347 28.6601 18.3667 +585 2 10.9021 14.6739 10.3387 21.4811 7.86907 3.51893 +586 1 6.88785 7.04202 15.6064 18.5625 21.2571 16.3476 +587 2 7.79496 7.28653 15.325 -16.282 -10.9681 -3.58347 +588 2 6.76913 7.58838 16.4136 -4.66142 -14.4555 -17.927 +589 1 8.00173 4.72633 13.4744 30.8534 11.0647 12.2619 +590 2 7.23536 4.76996 12.9314 -21.7993 1.23146 -17.3356 +591 2 8.43981 5.59806 13.3773 -8.25054 -18.6352 3.63378 +592 1 13.408 12.1818 14.2607 -3.38159 -13.7589 -5.77775 +593 2 13.0599 11.273 14.209 4.17969 5.9499 4.9999 +594 2 13.8015 12.3234 13.3884 0.552928 6.09909 4.73433 +595 1 14.8332 9.42219 7.30259 -3.18701 -8.441 -7.55641 +596 2 15.6639 9.86655 7.42287 15.173 5.4083 -0.0492361 +597 2 14.1987 10.0431 7.62107 -17.8235 6.30723 6.71627 +598 1 12.6528 17.0596 3.07812 -8.70602 18.4808 5.33985 +599 2 12.9496 17.4673 3.92869 -9.46791 -7.74089 -22.4319 +600 2 12.0101 17.6853 2.63014 23.5323 -19.7514 22.4129 +601 1 1.16198 7.14088 17.4585 -7.06812 8.47411 -13.2553 +602 2 0.305081 7.19087 17.9183 5.00325 -4.47293 -7.14563 +603 2 1.04973 7.54449 16.5661 0.440843 -6.25707 18.2149 +604 1 12.7703 5.1502 15.6519 20.537 -9.206 9.03076 +605 2 13.4569 4.49661 15.9358 -13.2491 19.9411 -11.3493 +606 2 13.2029 6.02791 15.5919 -0.675517 -15.6076 2.74775 +607 1 2.52973 3.39372 4.98628 -12.5021 24.9114 40.8727 +608 2 1.78336 3.12225 5.60975 27.8197 11.256 -19.0698 +609 2 2.94772 4.23746 5.36491 -19.3389 -38.1774 -13.5008 +610 1 8.3189 11.2987 13.4496 33.0028 -42.3062 59.2485 +611 2 8.52043 10.9592 14.374 -32.1909 27.8732 -26.3694 +612 2 9.06111 10.8351 13.0577 -1.72326 7.29715 -30.1092 +613 1 12.8789 1.33643 13.3362 0.40834 22.0058 -3.21803 +614 2 13.4118 1.44301 12.5159 -13.2456 3.30889 14.5055 +615 2 12.3632 2.16071 13.5095 17.0122 -18.2145 -15.4576 +616 1 6.34323 13.7037 2.15004 -8.90275 3.4942 1.01633 +617 2 5.67068 13.9831 2.80896 17.8093 -8.54249 -8.97759 +618 2 6.94017 13.0667 2.55763 -1.44693 0.407866 6.84109 +619 1 15.9207 6.60938 12.7941 -14.0219 -16.6873 -1.46208 +620 2 16.3665 7.21966 12.2297 10.4548 13.0291 -14.3606 +621 2 16.4032 6.61209 13.6164 4.57404 0.312906 11.3916 +622 1 16.837 0.713429 9.59537 -4.60186 -23.2491 -5.40047 +623 2 16.7766 18.3812 9.76009 1.861 23.059 -1.51736 +624 2 16.4539 0.846132 8.70764 2.52408 0.807103 8.64662 +625 1 6.14677 11.7538 8.37929 1.46343 -38.2042 -1.58984 +626 2 5.28119 11.5099 8.79312 19.6536 2.3972 -11.55 +627 2 6.62627 10.8955 8.13754 -23.51 30.7545 10.2414 +628 1 2.89887 8.61954 0.44521 -58.0253 1.44029 -30.8084 +629 2 2.28026 8.19904 18.4406 35.2092 -5.33136 7.34884 +630 2 2.23436 9.22701 0.790296 19.604 11.6332 17.9417 +631 1 10.1646 10.4607 6.5042 -2.67562 1.82661 -6.4385 +632 2 10.6119 9.73033 6.95167 0.990091 1.19991 -1.59039 +633 2 10.4858 10.4732 5.58284 -1.09389 -1.85789 13.424 +634 1 6.73063 15.6946 6.55447 -0.851851 -4.83477 5.20485 +635 2 7.09829 16.1491 7.32752 1.36873 0.436433 -10.1699 +636 2 7.02842 16.1335 5.74515 1.47904 6.69628 7.42626 +637 1 6.44804 13.1708 5.58287 -3.43311 -13.1021 10.8705 +638 2 6.66139 13.9646 6.07673 2.2473 5.97996 0.728386 +639 2 6.06157 12.5687 6.2363 0.868112 2.44944 -5.20285 +640 1 16.8203 12.5595 9.83963 -1.29973 -13.3798 -26.0882 +641 2 16.9797 11.9255 9.1094 -0.187484 2.38257 16.1818 +642 2 16.6351 13.3676 9.36293 0.809528 9.54538 5.72824 +643 1 6.04152 2.95052 2.84999 -1.13024 -25.4835 15.2707 +644 2 6.4006 3.79327 2.62573 5.01416 22.8678 -12.9444 +645 2 5.58314 2.5656 2.09763 0.434854 2.67004 -8.58918 +646 1 10.9107 3.32852 3.29939 -12.4238 -2.51051 -2.149 +647 2 10.2568 3.99067 3.55961 5.98057 0.0707186 3.553 +648 2 10.4887 2.88551 2.55708 3.841 -3.98893 -4.96007 +ITEM: TIMESTEP +20 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.69334 7.07477 17.9589 0.0661907 -8.15672 -5.93801 +2 2 7.76544 6.892 18.1438 2.06168 0.344835 4.67083 +3 2 8.87494 6.58302 17.1494 0.0923072 2.18051 2.08263 +4 1 18.5724 8.27759 6.8487 9.68108 -9.0135 5.9796 +5 2 0.0748736 7.96696 5.95521 0.0469709 2.78304 -15.7461 +6 2 0.399795 7.62446 7.38749 -2.21574 6.41883 6.02377 +7 1 8.4 18.5641 6.8134 3.87483 8.82198 -0.0595031 +8 2 9.32611 0.166963 6.70047 -3.24105 -1.28376 -0.166563 +9 2 7.89494 0.641414 6.41149 2.5055 -2.76566 0.153015 +10 1 6.59225 1.83896 11.6912 -0.275689 0.302437 5.80014 +11 2 5.92509 2.27303 12.2308 -4.07131 5.9643 -4.10931 +12 2 6.1821 1.00166 11.4658 -1.55571 -7.95905 -4.17259 +13 1 7.1255 5.73378 2.34451 -23.1841 27.0209 10.5427 +14 2 6.64356 6.29382 2.99422 10.5833 -21.9235 -2.45439 +15 2 6.93596 6.23963 1.54379 8.61204 -12.4491 -6.79559 +16 1 16.2118 10.162 16.1238 9.73263 11.3036 -6.58381 +17 2 17.0956 10.2901 15.7587 -2.05967 -6.96031 3.12171 +18 2 15.9212 11.066 16.279 -7.86411 -1.51367 3.55804 +19 1 10.6155 15.0016 2.3147 2.6864 2.11515 1.56294 +20 2 10.6002 14.5314 3.15674 -2.41534 -3.03603 0.679536 +21 2 11.0785 15.8209 2.51731 -0.0195897 0.981381 0.0978469 +22 1 17.1585 8.25197 10.4305 1.44624 0.93325 5.78222 +23 2 16.6499 8.94547 10.8694 -0.557047 -3.86734 3.9084 +24 2 18.0092 8.65295 10.2197 -0.225121 0.250414 -1.13708 +25 1 14.8741 15.8852 16.3481 -7.08493 -6.82471 0.413246 +26 2 13.9679 16.1979 16.3007 -7.09092 5.8218 -2.34027 +27 2 14.8494 15.2418 17.0641 6.82868 3.48864 5.90805 +28 1 12.1588 13.3817 0.433178 -6.27467 12.7595 -4.80914 +29 2 12.0352 13.6324 18.1551 4.79076 -7.76922 -3.88045 +30 2 11.6846 14.0735 0.910169 -3.08866 -6.36125 10.7585 +31 1 9.27449 5.40778 4.04397 -13.9365 -16.0184 3.55858 +32 2 8.80012 5.02015 4.81047 7.30704 13.9384 -9.37026 +33 2 8.62496 5.33174 3.3181 9.32114 8.483 4.67507 +34 1 1.82732 4.26294 11.6464 -4.04254 -2.69427 0.93532 +35 2 1.77693 5.20244 11.8864 -0.000737327 -7.07977 -0.141665 +36 2 2.24287 3.78422 12.3753 -0.858945 2.71416 -2.4423 +37 1 1.98268 6.82933 8.36887 -4.76513 2.22844 -15.7156 +38 2 2.36253 7.23451 9.15103 4.34961 -4.46197 5.21996 +39 2 2.01952 5.87123 8.47722 1.07428 0.125821 9.68028 +40 1 5.39566 4.39684 7.93565 8.0799 8.40992 8.79829 +41 2 5.46014 3.43633 8.01893 -3.87159 0.552259 -10.4859 +42 2 4.76986 4.63893 7.2446 -2.8004 -4.28351 -0.196723 +43 1 3.26324 2.92599 17.538 -6.48526 11.4036 5.90093 +44 2 3.9521 3.41084 17.0519 -4.33162 -2.5567 2.49087 +45 2 2.74469 3.58038 18.0606 14.1441 -6.64194 -12.4081 +46 1 7.47828 5.27232 6.10849 -6.04695 1.38866 -9.34596 +47 2 7.88111 5.94624 6.68322 -4.96979 -11.9122 3.47667 +48 2 6.82246 4.73008 6.58045 9.57964 11.031 7.72945 +49 1 9.77144 7.02208 11.9904 4.73189 -1.1383 -1.06285 +50 2 10.3467 6.38126 11.5734 3.30689 -2.46386 0.831607 +51 2 9.14216 7.24941 11.3005 -7.52384 3.80108 0.31383 +52 1 14.0798 3.55416 8.05513 -3.28328 4.35009 -1.93857 +53 2 13.7004 4.26501 7.52877 0.673114 -0.544944 -0.0617854 +54 2 14.5392 3.99696 8.77439 -0.252332 -0.945414 2.55344 +55 1 4.73763 17.2389 4.01031 -0.321378 8.61877 -17.0141 +56 2 5.59566 17.6635 4.11691 -0.835388 -5.76098 7.55997 +57 2 4.38449 17.6475 3.19969 -7.45685 -7.93836 11.3283 +58 1 16.5107 16.6056 10.0759 6.54448 8.81329 9.76337 +59 2 15.9397 16.7408 10.8388 -5.01232 -5.78767 -1.53078 +60 2 15.9723 16.2069 9.3894 -4.78788 -4.31379 0.495659 +61 1 1.96746 4.90416 0.450775 -1.81832 7.5424 0.20662 +62 2 2.57813 5.33173 1.07474 -1.76589 -7.7088 -3.71938 +63 2 1.58349 5.65244 18.6136 5.80255 -6.17515 -0.843526 +64 1 11.7761 13.343 16.2841 -6.04701 8.80367 11.8739 +65 2 11.2992 12.5177 16.4849 4.5736 1.77316 -11.3497 +66 2 12.2862 13.2596 15.4658 -7.12668 -12.5479 1.29578 +67 1 10.1128 11.0591 16.9331 1.69597 -16.074 1.546 +68 2 10.529 10.1874 17.0807 -3.30995 11.3925 -3.21813 +69 2 9.18388 10.849 16.7697 3.68635 3.27029 -1.84825 +70 1 11.7127 17.5197 13.4648 11.3019 2.11475 -5.22831 +71 2 12.331 17.0869 12.8651 -0.203424 -4.77186 2.96515 +72 2 11.9976 18.4453 13.422 -5.71015 -0.897636 4.76739 +73 1 6.35333 9.30557 12.2266 11.9787 8.60001 -4.91149 +74 2 6.91868 9.08658 11.4768 -7.06745 -10.6307 -2.02859 +75 2 6.87303 9.9972 12.642 -2.68502 3.03115 9.09234 +76 1 16.2229 12.7446 2.69624 -0.291567 -17.1772 2.14859 +77 2 17.0444 13.127 2.38556 1.82795 9.93981 0.639945 +78 2 15.5737 13.4355 2.84522 -0.398116 10.9003 -3.52894 +79 1 0.630414 12.571 5.87324 -2.78001 5.23525 -2.09291 +80 2 1.00794 12.4159 4.99822 -5.49855 2.79722 0.151968 +81 2 18.3568 12.8603 5.70082 10.405 -7.04854 2.54099 +82 1 5.20787 16.4001 18.4776 -12.5497 0.602195 -7.10426 +83 2 5.86464 15.8156 18.076 4.18722 4.70251 6.39081 +84 2 5.5918 16.9091 0.552483 9.38889 -4.76533 -0.723228 +85 1 0.52849 7.63403 4.08589 29.1287 17.8407 -12.6947 +86 2 18.5836 7.90722 3.36083 3.6478 2.13346 8.06342 +87 2 1.42012 8.03877 3.86645 -30.4536 -16.431 6.17599 +88 1 3.1381 8.91119 6.51072 -13.5755 -1.26875 13.9192 +89 2 3.59199 8.61596 7.312 -0.196935 0.713487 -8.34602 +90 2 2.19086 8.84537 6.73861 12.9731 1.00292 -6.41375 +91 1 7.31254 10.3111 16.1924 3.71601 3.69021 9.41051 +92 2 6.5835 10.5117 15.6001 -2.45726 -1.05124 6.16708 +93 2 6.97924 10.3433 17.1122 -4.5268 -1.10556 -13.1914 +94 1 11.1003 1.05051 4.99797 5.80988 -5.62906 14.1745 +95 2 11.3837 1.86623 4.56736 -9.38615 -1.44268 -8.87945 +96 2 10.7526 0.427875 4.34338 1.37635 7.2616 -4.61902 +97 1 4.41216 2.72626 13.196 4.39031 -15.812 27.2385 +98 2 4.68873 3.14242 14.0209 1.29771 13.5884 -6.24163 +99 2 4.35373 1.80262 13.5146 -5.93981 4.62314 -19.463 +100 1 8.39633 10.0477 1.8021 8.65231 5.58991 3.9521 +101 2 8.43584 10.7505 2.47552 -3.18527 -5.8592 -1.95349 +102 2 8.78245 9.25294 2.20632 -6.17245 6.11296 -0.869653 +103 1 10.5167 1.74791 15.5607 -12.987 -0.969766 6.95693 +104 2 11.4294 1.4693 15.6846 2.64548 4.13814 -6.20872 +105 2 10.3497 1.97094 14.6365 5.88046 -1.13362 -2.56443 +106 1 2.75172 12.9341 7.77038 -1.98364 -2.25212 -7.11701 +107 2 3.34024 13.5411 7.30753 1.72417 1.81116 5.40918 +108 2 2.20386 12.578 7.06153 -5.53374 1.90184 4.06344 +109 1 3.65904 11.6762 5.27167 1.4745 3.00351 -5.43274 +110 2 3.4246 11.0613 5.97769 -1.9036 -0.651658 -6.95213 +111 2 2.87422 11.8691 4.73548 4.37313 -4.77202 2.40024 +112 1 6.8497 14.4837 16.8623 -7.20011 -2.9268 7.54224 +113 2 7.64382 13.9472 16.8068 -1.68272 1.48794 -3.62778 +114 2 6.45279 14.5388 15.9848 5.36951 2.03983 -1.60361 +115 1 14.1732 14.5515 3.40534 8.00808 -4.71428 -5.83886 +116 2 13.686 15.3662 3.26714 -6.11485 0.946493 -0.0166146 +117 2 13.6673 13.9759 3.98664 -1.2314 3.40033 5.39954 +118 1 8.29912 18.1674 16.0589 -20.5282 -4.34905 -0.197762 +119 2 8.7408 17.3576 16.3653 13.9085 14.9544 -3.06277 +120 2 8.83266 0.312858 15.8727 12.6636 -13.3116 3.05514 +121 1 4.73053 1.62244 4.91728 3.73461 17.8941 -9.82498 +122 2 3.87083 2.07692 4.90413 8.70323 -5.84393 3.64668 +123 2 5.31846 2.19299 4.38363 -11.3635 -9.88313 3.69576 +124 1 15.0998 12.7921 16.4359 -16.5392 5.6559 5.83964 +125 2 14.613 13.1569 17.1797 9.93151 -3.40376 10.0434 +126 2 14.4182 12.7815 15.762 4.3611 -9.31248 -14.0367 +127 1 15.7898 18.3971 16.8042 5.79346 -1.22695 27.8179 +128 2 16.3329 18.5498 17.6117 -9.65553 4.21222 -20.1346 +129 2 15.4648 17.4968 16.9407 3.00983 3.14177 -9.23088 +130 1 1.14588 1.15091 16.5513 6.84042 -4.63386 -6.55399 +131 2 1.94328 1.67743 16.706 -5.62204 0.173811 5.06431 +132 2 0.528577 1.37004 17.2554 5.0728 5.5861 0.922174 +133 1 18.0913 4.5707 15.884 4.25376 -5.47852 -1.15194 +134 2 18.5654 4.01411 15.2573 -2.45188 0.25544 1.09753 +135 2 18.6545 4.64521 16.6589 -1.38654 0.113736 -2.45626 +136 1 12.2253 16.9711 16.1412 0.914186 -11.4555 3.91466 +137 2 11.5632 16.3741 16.5429 5.70701 14.4982 -7.43821 +138 2 12.0767 16.9746 15.1851 -6.52552 1.11271 2.73005 +139 1 15.9091 2.53324 17.9911 -0.813861 17.5084 -1.21546 +140 2 15.6764 3.36649 18.4268 1.17892 -6.2644 3.50604 +141 2 15.6868 2.72575 17.0644 4.5424 -10.5093 4.50867 +142 1 6.70264 13.8034 10.241 3.67042 13.5267 -3.47207 +143 2 6.65382 13.63 11.1889 -2.71481 -10.4168 -1.32753 +144 2 6.64075 12.981 9.74212 -1.13183 -3.39045 4.84834 +145 1 10.1303 18.2368 2.79334 3.88934 4.25391 -9.05815 +146 2 10.3528 0.228802 2.09034 -3.74927 -2.61302 6.3793 +147 2 9.24556 17.9143 2.58077 2.23777 4.46644 1.38681 +148 1 2.97822 17.7592 6.09436 6.84514 -11.0569 -16.6755 +149 2 2.2147 17.6257 5.53291 -18.2595 3.26089 9.16469 +150 2 3.66284 17.6557 5.427 11.9633 8.77303 4.67614 +151 1 12.5626 16.9639 7.98676 12.5848 -1.11028 -8.52053 +152 2 11.8839 16.2724 7.94525 -2.9484 9.81966 4.92503 +153 2 12.3706 17.6612 8.63222 -7.85492 -11.7975 4.91014 +154 1 14.885 15.2749 8.26678 1.09184 -13.1129 19.8008 +155 2 14.1202 15.8628 8.27106 1.10724 6.83397 -10.769 +156 2 15.4286 15.3633 7.48102 -5.52588 8.50153 -14.3957 +157 1 17.5862 18.2834 0.376986 -24.9344 -1.23553 -1.17468 +158 2 18.3469 17.8479 0.005767 18.8411 -2.89863 0.907383 +159 2 17.8259 0.448151 0.831731 10.0339 0.947456 -0.506579 +160 1 0.885899 10.3809 1.40397 7.22911 -11.5028 6.53987 +161 2 0.114071 9.81378 1.55479 0.851643 9.57639 -0.353744 +162 2 0.635753 11.1007 0.824785 -9.84019 7.34982 -5.0696 +163 1 1.59112 12.2023 3.3355 8.42913 -7.93475 21.5428 +164 2 1.38243 11.4488 2.766 -0.926106 10.11 -6.99043 +165 2 1.6499 13.0233 2.84482 -2.64968 -0.879455 -11.853 +166 1 0.551086 17.2511 4.8776 21.276 -3.63263 -24.3978 +167 2 -0.0762795 17.9651 4.97462 -6.3407 4.63135 13.3725 +168 2 0.558623 16.612 5.58807 -10.7338 -2.48853 14.1039 +169 1 1.11389 0.976548 9.40441 -9.70348 2.26791 0.52143 +170 2 1.20067 0.739298 10.3296 11.5619 -5.66825 6.05541 +171 2 0.194683 0.747268 9.24308 -0.993818 -3.51563 -8.196 +172 1 16.7801 2.33697 13.2827 1.26658 -2.58515 -3.42214 +173 2 16.9917 2.52603 12.3542 -2.2694 -1.44301 7.47438 +174 2 16.5315 1.40163 13.3451 -1.6586 3.84983 -3.29893 +175 1 2.50653 15.8317 12.198 6.9942 0.0378495 -5.39106 +176 2 3.03319 15.4932 12.933 -2.33393 0.151651 -5.20129 +177 2 2.92041 15.5438 11.3652 -1.63849 1.19534 6.62391 +178 1 16.4211 15.5676 5.95733 20.9565 28.2944 1.83954 +179 2 17.3426 15.5843 6.27645 -8.81355 -7.9692 1.26231 +180 2 16.3612 16.4166 5.46885 -9.28613 -17.0928 2.60564 +181 1 5.82453 5.03389 11.7824 5.33446 0.320875 1.57619 +182 2 5.57998 5.74431 12.3877 -7.39983 3.16893 -2.12011 +183 2 5.27405 4.27426 12.0034 -1.54313 1.61628 -0.196815 +184 1 15.2115 4.85871 0.718957 -12.3292 -1.21553 20.1953 +185 2 14.9951 4.64926 1.65891 1.99725 2.35951 -19.8125 +186 2 14.3839 5.18637 18.9796 8.05664 -2.8997 2.32554 +187 1 16.3489 16.3233 2.11444 -1.37403 -13.232 -8.15517 +188 2 15.9103 16.7203 2.87049 4.10511 7.42013 3.0617 +189 2 16.5474 17.0218 1.48672 0.743353 6.63736 2.3016 +190 1 0.282027 4.87119 3.80055 19.2835 17.3487 3.53091 +191 2 0.489613 5.83173 3.76503 -11.8967 -17.4303 3.14809 +192 2 1.11089 4.48306 4.11838 -9.18259 -2.61174 -2.176 +193 1 2.9303 15.0125 15.0392 0.0573492 -0.181072 31.7668 +194 2 2.82615 14.584 15.9186 6.41531 2.15453 -14.4377 +195 2 2.5906 15.8967 15.228 -6.81336 0.182398 -11.4579 +196 1 1.12223 14.6049 9.5632 13.1187 -18.7351 -0.898815 +197 2 1.97867 14.3698 9.19328 2.71847 14.7063 -6.21023 +198 2 0.940175 13.7592 9.98602 -14.9991 7.00648 6.43026 +199 1 13.665 16.6454 11.5316 -21.8339 3.0331 3.55613 +200 2 13.1746 17.4327 11.223 10.4467 -7.06131 -5.36321 +201 2 13.1002 15.9021 11.2581 8.49503 1.30575 -4.9094 +202 1 4.71709 1.47693 0.719081 -0.792104 -2.26487 7.67979 +203 2 4.13723 2.08795 0.242023 0.0358417 -6.61504 -0.0652634 +204 2 4.16248 0.903426 1.27536 -1.89276 3.42768 -9.42283 +205 1 1.43372 18.4947 11.8904 0.435024 0.903574 -5.06079 +206 2 1.25876 0.369488 12.6813 0.171373 0.403899 4.07674 +207 2 1.76959 17.6363 12.1756 0.0129122 3.12302 0.145238 +208 1 11.5344 10.1145 4.09755 11.0508 4.0163 -22.2825 +209 2 11.4066 10.5292 3.21014 2.38528 -6.34716 18.1192 +210 2 12.5036 10.0411 4.22804 -15.2135 3.993 -1.98571 +211 1 8.36281 12.1777 3.74701 -13.1943 -6.81146 -12.1909 +212 2 9.18722 12.6378 3.9579 -8.09176 1.3179 12.2751 +213 2 7.70079 12.2682 4.46238 18.0882 5.10492 -3.45512 +214 1 14.3344 4.02288 3.28855 15.2498 3.93213 6.6836 +215 2 15.0617 4.23514 3.91062 -12.0049 -4.72392 -3.76747 +216 2 13.5379 4.47251 3.60621 4.75183 0.0120405 -3.02562 +217 1 5.58434 1.74596 7.50985 -22.3692 -26.8297 9.12948 +218 2 4.91823 1.11394 7.92632 27.2868 23.8434 -15.8784 +219 2 5.43743 1.67946 6.54893 -3.28939 1.24453 9.56906 +220 1 17.9012 1.11073 4.88195 -3.31078 -7.47428 -4.80941 +221 2 18.5525 1.45486 4.25184 -3.70144 3.91348 6.86656 +222 2 17.7599 1.74881 5.59037 4.24211 2.13046 -3.7457 +223 1 6.8304 9.4053 4.48372 -13.6803 0.789023 -7.06041 +224 2 6.74666 9.48009 5.43928 9.48337 1.88908 4.46236 +225 2 7.74899 9.21301 4.27057 2.55497 -2.6247 5.048 +226 1 2.68932 14.9418 1.9668 -6.12139 1.43036 2.89635 +227 2 3.30587 14.7185 2.6759 1.77318 0.618157 -6.66396 +228 2 3.15681 14.9246 1.12432 2.70839 -4.47578 5.21755 +229 1 17.2859 12.889 13.1454 -5.46423 18.1991 -4.92566 +230 2 16.4361 13.3067 13.278 -15.9577 -14.9195 9.16742 +231 2 17.7285 13.6846 12.8505 24.3586 -1.49654 -2.29875 +232 1 15.0069 10.5712 1.38624 -2.11062 -3.1818 -0.491761 +233 2 15.5786 11.255 1.74854 2.03128 0.359313 2.4477 +234 2 14.2323 11.0405 1.08579 -5.34855 2.20107 -0.889893 +235 1 5.70672 6.90314 4.53443 4.24519 -5.28557 8.89432 +236 2 5.96576 7.83558 4.52332 0.860976 -3.32444 -1.54743 +237 2 6.34045 6.45199 5.11743 -0.773999 0.740319 -5.54545 +238 1 8.07933 8.28074 10.2171 -3.64639 -3.67369 23.1077 +239 2 8.76707 8.87858 9.90894 -2.7343 3.77639 -10.7375 +240 2 7.6749 7.81667 9.48055 2.86655 5.40525 -7.79011 +241 1 13.5084 18.3075 5.79227 -0.609935 12.5659 -0.945985 +242 2 12.8781 0.387145 5.63591 -2.7451 -9.905 0.332396 +243 2 13.1846 17.8335 6.57076 -1.7745 -1.29433 -5.46225 +244 1 0.277736 2.58212 0.118598 0.621477 -2.00702 8.56184 +245 2 17.957 2.7127 18.6839 10.2871 11.0559 -0.501636 +246 2 0.794319 3.38844 0.33639 -19.4232 -4.52538 -3.88061 +247 1 12.6801 10.9983 9.7602 -12.9965 -11.6862 -0.561246 +248 2 11.7228 10.8953 9.6485 6.19444 12.5166 -3.56604 +249 2 12.897 10.0826 9.9647 14.0656 0.707903 4.64438 +250 1 0.781933 12.2574 11.0872 -6.04901 -2.18816 6.07288 +251 2 18.4712 12.3682 11.1342 -4.62852 -2.97634 -7.25325 +252 2 1.06266 12.4852 11.9795 7.76729 1.60409 -2.26455 +253 1 5.05561 7.24886 13.466 -11.4852 -6.03635 -4.86876 +254 2 5.50236 8.03712 13.1394 10.7241 -0.576345 -1.34855 +255 2 5.49314 6.97472 14.2774 5.89817 7.37955 3.96262 +256 1 1.26581 6.94402 11.8396 4.62667 -0.613543 7.50244 +257 2 0.504801 7.20295 11.3208 -2.84364 2.86798 -1.49635 +258 2 1.66495 7.76854 12.1529 -2.34869 -3.61795 -5.23307 +259 1 15.4733 9.48228 12.3076 -4.70583 25.6475 16.0975 +260 2 15.3149 10.4406 12.4106 2.52372 -12.0579 -11.0564 +261 2 15.3983 9.16189 13.2139 2.67764 -6.7615 -6.72177 +262 1 16.6336 12.9201 5.4628 6.66579 -20.8603 16.0577 +263 2 16.5173 13.872 5.54201 -7.55482 0.841067 -13.5204 +264 2 16.4587 12.5944 4.56908 -1.3904 13.4091 -1.6671 +265 1 6.18458 10.0203 0.145227 10.7922 -3.52818 2.39688 +266 2 5.51531 10.431 0.700604 -4.05423 0.759005 -2.7608 +267 2 6.99302 10.1148 0.667984 -1.67417 -4.19008 -1.28624 +268 1 12.3589 6.06668 4.038 0.452115 -1.15559 12.336 +269 2 12.2616 6.902 3.56852 -2.7325 -0.676505 -9.18667 +270 2 11.4806 5.67315 4.10483 0.607886 2.8799 -4.57435 +271 1 0.151536 12.8218 0.203335 4.13456 -2.94622 -2.33064 +272 2 -0.0129983 13.5003 0.871422 4.06521 1.52419 -2.90371 +273 2 18.34 13.1254 18.0507 -1.07008 -0.669132 2.22617 +274 1 3.8124 18.585 8.59267 3.71655 -0.510361 5.11861 +275 2 3.56708 18.0759 7.80793 -6.58546 5.02297 1.51156 +276 2 3.01311 0.371537 8.92178 -4.29721 -3.94788 -5.16471 +277 1 7.41673 17.2735 4.46563 5.27699 16.8729 -12.8498 +278 2 7.96434 18.0381 4.66458 -2.5447 -1.66977 13.1327 +279 2 7.34622 17.3735 3.5102 -3.86431 -11.0257 -0.167405 +280 1 9.22722 17.0589 12.2393 19.2623 -14.5641 0.108859 +281 2 9.27149 16.2912 11.647 -4.87121 6.1965 2.03703 +282 2 10.0709 17.0037 12.729 -13.5572 10.6592 -2.64279 +283 1 13.3059 12.9585 7.95053 -5.93488 5.61094 -2.56551 +284 2 13.3162 12.2379 8.59837 1.79032 5.44422 0.740585 +285 2 13.8923 13.6822 8.21069 6.53108 -7.176 5.15054 +286 1 14.9676 2.9565 15.3436 -0.386658 0.574387 3.68052 +287 2 14.4202 2.18777 15.1252 1.77471 7.19316 -4.43588 +288 2 15.6633 3.03092 14.6718 -7.27619 -4.52831 0.823712 +289 1 9.86266 15.5244 17.0043 3.51131 -4.56125 -2.22878 +290 2 10.4016 14.759 16.7592 -3.4195 -0.793849 -1.98877 +291 2 9.23782 15.2217 17.674 1.65588 4.18023 5.21634 +292 1 11.2982 8.26605 16.5436 5.00814 15.3472 3.18516 +293 2 10.6561 7.79454 16.0057 0.999826 -4.04983 -0.0472571 +294 2 11.6606 7.65108 17.1873 -4.09078 -4.29715 -0.00155616 +295 1 3.81225 18.1964 16.7292 10.4788 2.16731 8.30533 +296 2 4.28955 17.5863 17.3008 -0.586781 -10.0924 -3.62086 +297 2 3.8829 0.368785 17.226 -6.17555 6.78007 -4.03101 +298 1 2.19803 4.12169 8.95254 -8.42555 5.0907 -8.8117 +299 2 3.07539 3.82533 8.67919 -2.6088 -0.1453 11.8715 +300 2 2.06404 4.00225 9.90658 13.5851 0.597917 -5.47855 +301 1 9.88178 10.3569 9.73038 4.79618 9.75255 -1.56513 +302 2 9.58096 11.2105 9.34815 0.270313 -13.7408 11.2463 +303 2 10.0884 10.4563 10.6769 -5.68787 3.60286 -6.41077 +304 1 9.72212 0.809424 10.8539 19.6856 13.2875 8.50656 +305 2 9.35568 18.6419 11.2241 -8.56647 -0.801274 -6.22283 +306 2 9.1718 1.19131 10.1642 -10.1616 -7.34852 -1.36201 +307 1 9.20808 15.1775 10.2123 -15.4381 -3.13199 6.73164 +308 2 8.85567 15.9769 9.80113 1.42232 -2.21967 -3.83769 +309 2 8.41617 14.6283 10.3808 11.8702 3.92611 -8.2586 +310 1 0.995689 9.3369 10.3259 -16.0333 -0.722577 -1.64132 +311 2 1.04111 10.3025 10.3672 11.5337 -2.90556 1.12718 +312 2 1.85551 8.94205 10.1494 2.50931 13.4523 1.23502 +313 1 16.8622 4.87275 8.19393 -0.422934 0.254968 7.2846 +314 2 16.1689 5.44633 8.57547 10.3862 -6.79292 -0.962882 +315 2 17.2033 4.29721 8.90095 -5.62498 7.92604 -8.45296 +316 1 14.656 14.7011 0.368319 0.981504 1.6367 -2.03469 +317 2 15.1464 15.0731 1.12238 -4.61865 -0.709772 -8.09446 +318 2 13.8079 14.3976 0.718239 6.88081 -1.79732 0.157513 +319 1 3.54139 11.054 9.61635 4.40574 2.25524 -6.23941 +320 2 3.65641 11.5568 10.4349 -3.33961 -4.79202 -0.629126 +321 2 3.06202 11.6341 9.00365 5.95536 0.511998 4.3162 +322 1 11.0657 10.8474 1.29636 2.92174 -3.12366 4.90686 +323 2 11.2982 11.6263 0.767958 -3.5102 -3.65436 5.75862 +324 2 10.1232 10.6698 1.15822 5.54645 2.63321 -1.67034 +325 1 13.2072 7.07995 12.8701 -0.715054 4.17079 -6.48984 +326 2 14.1512 6.89692 12.9697 -2.29399 1.70307 -2.36257 +327 2 12.7789 6.22148 12.7926 -0.519741 -2.64677 3.01569 +328 1 9.62848 1.89714 0.960589 0.144249 -1.27383 8.14422 +329 2 8.75389 1.7191 0.595255 2.62606 0.878667 -4.42234 +330 2 10.2646 1.96201 0.242782 -4.84565 1.17493 -5.89222 +331 1 10.5889 13.5223 4.7138 2.80012 2.67941 -15.7349 +332 2 11.4734 13.1444 4.59356 -4.0194 -1.02806 11.2737 +333 2 10.6142 14.0248 5.53615 3.92037 -3.05166 -0.671 +334 1 14.2891 1.71547 10.914 14.736 9.54636 -9.28817 +335 2 15.0906 1.40219 10.4788 -2.27816 -10.6125 3.67971 +336 2 14.438 2.66833 10.8812 -8.3278 1.7804 6.62982 +337 1 14.6539 12.3888 11.7057 -9.85382 -5.79197 9.84531 +338 2 15.5174 12.4906 11.2689 -13.4179 -5.72309 -9.10321 +339 2 13.9464 12.0325 11.1297 19.1264 4.07718 -1.67851 +340 1 8.24463 5.07042 9.80489 8.67652 16.3821 0.210642 +341 2 7.41075 5.25266 10.2586 0.116202 -10.888 -2.54867 +342 2 8.19641 4.23298 9.33202 -10.3006 -5.74151 5.58561 +343 1 1.57762 16.8331 18.335 1.68687 -2.26048 -0.033424 +344 2 1.80587 17.1847 17.4697 -0.252498 3.71983 1.68741 +345 2 2.01633 15.9753 18.3429 -7.29056 -3.61139 0.997127 +346 1 1.4432 17.2346 15.332 2.65894 -7.35401 -5.7102 +347 2 1.56202 18.0921 15.7447 -7.04866 6.37518 1.22888 +348 2 0.495246 17.0477 15.225 10.7628 4.03376 7.259 +349 1 3.71499 5.60328 6.17396 -2.46237 18.0728 1.59518 +350 2 3.14409 6.20568 6.67532 2.19379 -7.75625 0.984178 +351 2 4.32024 6.21155 5.72591 -1.08806 -7.05296 -5.84211 +352 1 12.3532 9.43776 14.1893 13.0079 -11.8089 -5.25996 +353 2 12.7562 8.63341 13.7793 -8.52026 15.4152 14.9752 +354 2 12.1872 9.21442 15.1219 0.0848175 -4.0166 -10.4276 +355 1 4.03165 15.279 6.91423 11.4052 5.55751 -7.84178 +356 2 3.54353 15.996 6.48767 -3.99323 -1.71496 7.04649 +357 2 4.96733 15.4866 6.74143 -6.91754 -4.3684 4.91577 +358 1 0.598678 8.56195 14.8837 5.20406 11.6905 0.774862 +359 2 0.593362 9.51845 15.0326 -4.59172 -3.85379 3.33684 +360 2 1.20863 8.47913 14.1435 0.530109 -4.80423 2.60663 +361 1 12.9822 8.33824 10.332 -12.7812 8.13505 -15.7365 +362 2 13.7449 7.91273 9.91994 1.65618 -4.07378 8.99333 +363 2 12.9305 8.07685 11.2552 9.52621 -6.7264 2.9301 +364 1 15.3077 7.66451 3.49902 -16.235 -26.2008 20.478 +365 2 14.5457 7.14577 3.24297 -4.72624 11.0142 -23.2354 +366 2 15.4625 7.21195 4.33822 21.3334 18.0327 3.91528 +367 1 17.3129 6.65992 0.0418436 1.52354 1.06354 -1.27952 +368 2 16.9014 5.84978 0.373955 -3.48337 6.90323 -1.87832 +369 2 16.58 7.23266 18.3971 4.62858 -6.17573 2.16922 +370 1 8.83009 6.92284 7.82744 0.252992 -5.92817 5.57761 +371 2 9.76137 7.15634 7.81451 4.22584 7.3373 -3.58966 +372 2 8.73794 6.33872 8.59756 -2.97854 -0.622916 -4.66555 +373 1 12.3396 0.625886 1.18148 -8.16379 -0.652746 9.01197 +374 2 13.1345 0.755236 1.71568 4.24005 -1.61972 -8.33969 +375 2 12.5055 18.5332 0.58867 3.80642 2.13695 -0.293066 +376 1 5.66619 15.1148 14.5143 -6.5884 11.0519 3.391 +377 2 4.74474 15.2404 14.7783 -0.0534379 -6.99417 -3.01637 +378 2 5.9729 15.9975 14.2655 4.1321 -4.56061 -2.72375 +379 1 3.84883 6.51764 1.70764 -0.24517 -12.2729 -5.84301 +380 2 3.34882 7.24325 1.31145 3.38543 6.95106 5.25371 +381 2 3.97654 6.73657 2.63696 -3.88246 4.168 -0.0932901 +382 1 3.88114 11.6142 12.2659 5.57001 4.81087 6.19714 +383 2 4.75444 11.9544 12.4977 1.45427 -2.38077 -3.49117 +384 2 3.27884 12.2304 12.6965 -5.21243 -4.02352 0.863052 +385 1 5.43603 3.86764 15.8623 7.54926 19.6814 5.52869 +386 2 6.13377 3.21124 15.7334 -3.30504 1.34649 -4.68995 +387 2 5.89589 4.73554 15.9355 -10.2176 -19.0214 -2.32011 +388 1 14.4546 10.3201 4.4055 -4.6195 -17.8145 -6.66778 +389 2 14.5894 9.8066 5.2203 1.29615 2.58376 -6.73886 +390 2 14.6351 9.71867 3.64602 0.226975 12.0799 18.4878 +391 1 7.91148 17.3357 9.20787 -1.7112 -7.64626 2.59046 +392 2 7.14677 17.4921 9.78359 1.89149 7.49144 -9.53339 +393 2 7.98506 17.9868 8.49476 -7.16328 0.988414 5.46347 +394 1 4.5072 14.4394 3.95775 1.71054 11.4257 7.67338 +395 2 4.60793 15.3916 4.19235 0.708777 -20.878 -0.615863 +396 2 4.75094 13.8726 4.71695 -2.09911 13.0171 -9.33913 +397 1 14.3103 7.38832 15.7657 0.217846 1.64546 9.18842 +398 2 15.2433 7.23588 15.5844 -0.0812074 1.42566 -0.574095 +399 2 14.3036 7.75428 16.6621 0.0607731 -0.988243 -5.21848 +400 1 2.8988 18.2304 1.89629 8.58281 11.0644 9.98123 +401 2 2.46496 17.5082 1.44481 -2.59003 -3.64619 -8.76243 +402 2 2.19471 18.7603 2.28641 0.940953 -0.0494932 1.95923 +403 1 7.97286 1.6093 4.54004 -3.7555 -8.8471 12.6183 +404 2 7.33734 2.04506 3.96057 8.79876 5.02214 -6.32296 +405 2 8.86006 1.965 4.43164 -2.78989 3.02833 -7.03085 +406 1 2.61876 14.1356 17.7492 -10.3822 -13.3904 -3.64852 +407 2 1.93119 13.4601 17.9363 9.46205 16.209 2.13837 +408 2 3.45643 13.7285 18.0162 -4.37303 1.24885 0.341178 +409 1 0.743255 1.70456 13.8731 3.59522 3.89384 -8.23695 +410 2 0.90651 1.38191 14.7629 -6.62821 1.47751 3.8543 +411 2 18.4338 1.82907 13.7582 5.96409 -0.15878 4.57237 +412 1 4.54424 18.6047 13.95 -3.57477 5.05027 -2.13798 +413 2 5.48468 18.3837 13.9843 -5.3566 -3.00882 -0.547935 +414 2 4.15141 18.3634 14.8001 4.77528 1.99072 0.545271 +415 1 7.0969 0.526127 18.3635 1.96349 3.45814 -4.17057 +416 2 7.27221 0.201121 17.4702 1.10961 -1.44826 4.33327 +417 2 6.13787 0.588122 18.4485 3.2238 7.1666 2.24 +418 1 16.0917 18.4266 14.1084 2.59329 0.57669 -10.3481 +419 2 15.3502 17.9157 13.7545 1.31994 6.64432 9.22997 +420 2 15.9271 18.7357 15.0116 -3.89333 -11.6647 -1.43214 +421 1 10.0733 4.52495 16.275 12.9842 -2.30982 2.85456 +422 2 11.0043 4.70153 16.4703 -2.64404 5.32532 -3.085 +423 2 10.0864 3.57376 16.1251 -6.72333 -0.470122 -1.54666 +424 1 15.8636 17.8904 4.42819 -6.03116 8.53171 5.31621 +425 2 16.3871 18.7073 4.48664 -0.23776 -8.88425 -2.03055 +426 2 14.9745 18.1441 4.72479 9.46919 -4.85854 1.60726 +427 1 6.9475 17.372 13.7315 15.8768 1.84738 17.2901 +428 2 7.36738 17.5483 14.6019 -4.78498 1.02898 -17.1267 +429 2 7.68915 17.2477 13.1142 -8.54431 1.43966 5.77183 +430 1 13.2923 6.53747 6.71701 -11.5961 -7.93952 14.6915 +431 2 14.1983 6.84596 6.64723 3.17712 4.25021 -11.0614 +432 2 12.8934 6.43009 5.84838 7.58936 1.28323 -8.80485 +433 1 7.69653 2.37351 9.2065 12.517 1.33593 -3.6252 +434 2 7.21057 2.29 10.0355 -5.39375 -0.506169 -1.44147 +435 2 7.12159 2.1318 8.46594 -3.32624 -2.43573 8.05936 +436 1 15.157 14.8759 13.6545 4.5209 -3.06988 2.24561 +437 2 15.0369 15.0852 14.5928 -3.37623 1.75424 -5.30162 +438 2 14.3708 15.1144 13.1546 1.18854 2.2818 3.55032 +439 1 9.31032 8.32311 3.71462 16.317 -0.492826 6.27183 +440 2 10.1522 8.77498 3.89843 -7.06732 -0.949504 -0.86517 +441 2 9.4815 7.39306 3.91425 -6.58464 2.05554 -3.01208 +442 1 17.7054 13.4931 16.4528 -2.79698 17.5255 -9.98682 +443 2 16.7518 13.3863 16.3682 2.15912 -8.30505 3.41837 +444 2 17.8443 14.3312 15.9805 5.97419 -5.13367 5.17943 +445 1 5.02162 10.6562 2.64136 -2.02283 -9.27068 2.47877 +446 2 5.69056 10.1772 3.15718 -2.95942 7.94984 0.663407 +447 2 4.59516 11.2797 3.2389 2.78246 -2.35968 2.10645 +448 1 3.7261 8.35111 10.2906 -2.0647 -5.12326 -12.4171 +449 2 3.87558 9.26669 10.0174 -1.23075 2.88832 6.28188 +450 2 3.61938 8.33938 11.2471 1.47542 3.72119 -0.959794 +451 1 16.077 7.09208 6.26442 0.512876 -15.8531 0.565556 +452 2 16.8498 7.55114 6.61759 -4.58181 2.74438 -1.19615 +453 2 16.2841 6.14901 6.36212 0.103861 8.35624 -6.71996 +454 1 15.1586 7.03156 9.12145 1.35056 8.00181 -20.3615 +455 2 15.9739 7.38238 9.50783 -5.19642 1.69713 -0.962803 +456 2 15.0724 7.48187 8.24992 4.14438 -5.93719 19.2407 +457 1 6.4279 13.1173 12.8809 -5.50985 -11.8139 -9.3985 +458 2 7.12916 12.5687 13.2568 1.68182 7.24531 -2.67671 +459 2 6.29661 13.8986 13.4214 -0.338885 -0.946459 7.65298 +460 1 12.1214 4.48617 13.0834 13.9874 7.50725 -12.3985 +461 2 12.203 4.65044 14.031 -7.85782 -1.77094 2.73271 +462 2 11.2673 4.11709 12.8488 -4.68474 -5.36964 10.3853 +463 1 11.3361 8.19542 7.84742 15.1179 -11.1226 16.1752 +464 2 12.0446 7.62229 7.53485 -1.89389 0.170875 -13.8157 +465 2 11.6069 8.28902 8.77112 -9.48953 8.11742 -0.143346 +466 1 17.184 10.7876 7.43369 13.5323 -0.921102 -17.174 +467 2 17.9233 10.1981 7.20811 -10.1233 -1.22821 11.3165 +468 2 17.1161 11.3267 6.63249 -5.49276 7.55364 9.36769 +469 1 5.23991 18.1348 11.0582 -10.3762 -3.21686 -5.77572 +470 2 4.63631 17.985 11.8048 7.12888 1.45886 -5.61107 +471 2 4.69408 18.0516 10.2533 5.93648 2.65605 9.16476 +472 1 7.56507 17.5919 1.8299 2.38736 9.59194 1.23507 +473 2 7.95273 16.7967 1.45285 -6.05148 -1.8022 -9.76241 +474 2 7.59068 18.2848 1.14776 -2.89899 -11.2976 1.8216 +475 1 1.88529 12.921 13.6059 -1.54804 -3.98178 5.6231 +476 2 1.43748 12.3178 14.2147 5.26513 0.934067 -3.79148 +477 2 2.14524 13.6768 14.146 -0.717118 1.88599 -5.70238 +478 1 9.71545 6.78651 14.8047 -15.2171 15.1422 7.50698 +479 2 9.90531 5.90708 15.1331 4.86835 -12.5985 -3.10865 +480 2 10.0627 6.91606 13.92 3.16992 -4.80507 -4.41639 +481 1 15.2317 4.3547 10.7806 -19.2619 -13.8042 -17.3299 +482 2 16.1692 4.17769 10.7161 9.63774 3.67614 12.8518 +483 2 15.0389 5.06132 11.3962 11.3469 5.0749 6.12787 +484 1 11.2086 6.13697 0.180528 -13.4008 -14.4307 -10.9666 +485 2 11.2654 5.18187 0.0337896 12.1183 5.06406 4.26486 +486 2 10.2799 6.29806 18.6081 2.85376 11.1709 5.84358 +487 1 0.155975 11.3317 15.1259 -12.2739 12.4049 -22.3111 +488 2 18.2869 11.6878 14.3448 9.29886 -6.35489 23.8975 +489 2 18.7388 12.0248 15.8046 -8.78344 -4.02614 -5.34871 +490 1 7.07225 9.17108 7.27057 -4.95781 3.28344 -6.42365 +491 2 6.44778 8.45946 7.46529 5.34767 -0.253084 5.87629 +492 2 7.94637 8.76128 7.25029 -3.14507 0.531691 2.27088 +493 1 18.4147 15.4309 12.3592 -5.86353 -0.606553 -5.09086 +494 2 0.72281 15.5186 12.2612 4.29187 -2.85716 2.67478 +495 2 18.0791 15.7216 11.5043 -3.32345 0.421348 1.66841 +496 1 16.5543 4.36503 5.23509 20.0373 -2.39618 26.5758 +497 2 16.7455 4.21973 6.1845 -16.121 -2.23612 -11.2684 +498 2 17.4558 4.42117 4.89188 -6.1573 5.26009 -14.9538 +499 1 17.766 3.07261 10.7271 -5.62269 10.8805 -1.85707 +500 2 0.0408353 3.2985 10.945 -3.12308 -7.03453 -2.35326 +501 2 17.719 2.23067 10.252 6.41295 1.44898 4.1666 +502 1 12.3026 0.0397215 10.1517 -5.9029 17.7484 6.25384 +503 2 11.458 0.404705 10.4688 2.82225 -9.87605 -6.68676 +504 2 12.8944 0.808865 10.1781 1.22751 -9.09827 -0.112681 +505 1 10.357 9.81077 12.3435 10.1956 0.0137966 -0.104503 +506 2 11.132 9.85287 12.9219 -4.83247 1.57396 1.64677 +507 2 10.2731 8.87192 12.148 -4.78867 -1.2901 1.32484 +508 1 0.505846 2.83821 7.01562 3.91094 -2.13436 13.3247 +509 2 0.681162 3.5182 7.67504 1.89272 4.99945 -7.1411 +510 2 0.694039 2.0503 7.53478 0.801338 -5.04329 -7.26695 +511 1 0.437103 15.2686 6.90942 10.3075 -26.8847 6.28938 +512 2 0.575652 15.2733 7.87231 -4.50905 3.86257 -7.07916 +513 2 0.764375 14.3681 6.66626 -11.1886 22.2654 -1.84191 +514 1 16.9895 7.01682 15.3107 -21.8777 2.45652 -5.46979 +515 2 17.7216 7.6089 15.1142 9.4824 -7.00642 -0.959024 +516 2 17.2645 6.09907 15.4073 14.9833 2.67634 2.96399 +517 1 9.01274 12.4171 8.12853 10.6441 15.1284 15.6095 +518 2 9.41612 11.8292 7.47716 -12.8498 -4.61215 -9.56742 +519 2 8.05003 12.5053 8.0704 6.97129 -9.84551 -10.1137 +520 1 1.26391 1.92336 3.04659 2.32337 -11.3487 -0.982019 +521 2 0.972058 2.42084 2.27545 2.43588 3.35199 3.68236 +522 2 1.90572 2.43981 3.5544 -5.46738 3.49891 -6.33947 +523 1 4.13143 15.1122 9.67174 -10.3949 2.47722 13.8895 +524 2 4.06276 15.2642 8.72313 5.39511 -1.60046 -0.0768584 +525 2 4.99495 14.7433 9.87874 3.88633 -1.07729 -6.21534 +526 1 7.19145 2.18155 14.5787 4.86443 0.520714 0.489557 +527 2 6.89453 1.81445 13.7426 1.87671 -5.23084 1.53267 +528 2 7.73681 2.92919 14.317 0.289792 2.5421 2.67041 +529 1 18.6 14.6947 2.16091 -2.26171 3.41683 0.482467 +530 2 0.820032 15.117 2.19003 5.03273 -5.31768 -1.38278 +531 2 17.9827 15.4314 2.17519 -7.65677 -2.44766 2.74205 +532 1 9.95161 2.77613 12.9401 9.45852 -1.28953 0.462065 +533 2 9.84872 2.18467 12.1812 -5.82301 1.90383 1.05008 +534 2 9.27924 3.46642 12.8986 -6.28602 -3.28272 -2.83121 +535 1 2.83159 8.92314 13.0298 -5.32883 -6.03653 -2.71455 +536 2 3.23927 9.77312 12.842 3.02047 6.8466 -0.359778 +537 2 3.51958 8.34046 13.3637 5.40811 -1.61307 4.23789 +538 1 3.22435 8.37789 3.65229 -1.03338 2.31116 19.4552 +539 2 3.68753 9.01983 3.09696 -0.346577 4.63804 7.35474 +540 2 3.38788 8.57936 4.60408 0.951973 1.27409 -22.7571 +541 1 5.6137 7.19416 8.52025 7.21613 5.80474 -6.44533 +542 2 5.78863 6.24316 8.52523 -9.99458 0.454093 3.85202 +543 2 5.0179 7.43184 9.24037 0.527922 -7.72891 3.36669 +544 1 14.8805 1.29251 2.00129 6.0675 21.6566 -5.88084 +545 2 14.8065 2.10545 2.50153 -6.7285 -1.94379 16.9269 +546 2 15.1655 1.66296 1.16284 -0.437229 -14.9075 -12.229 +547 1 8.26451 15.1933 0.836486 3.22704 -2.0235 12.9462 +548 2 8.92324 15.2163 1.54184 12.9519 -3.35665 -8.03315 +549 2 7.55879 14.6837 1.25205 -6.95241 0.364363 -7.46808 +550 1 15.625 1.34415 7.23495 -17.3283 -0.11068 -5.87671 +551 2 14.9596 0.769214 6.81661 10.6011 2.38946 3.65492 +552 2 15.1493 2.17629 7.38417 4.13791 -2.68619 2.35471 +553 1 4.93041 13.0764 18.5264 9.84655 1.48115 -2.02825 +554 2 5.35318 13.1968 0.744685 -3.49153 -1.64799 -2.34468 +555 2 5.56664 13.4414 17.8965 -2.33559 -1.35641 1.38511 +556 1 15.3557 8.48379 18.1448 0.204246 14.4785 -5.82183 +557 2 15.7265 9.09289 17.4831 -0.830936 -8.68367 1.885 +558 2 15.168 9.07051 0.245745 1.7123 -4.50429 2.39894 +559 1 12.0892 3.02993 18.3645 -15.9576 34.4498 -4.49703 +560 2 11.9769 2.60431 0.571005 13.6468 -16.1673 -1.05926 +561 2 12.5269 2.48004 17.7153 4.47893 -15.6345 5.41851 +562 1 13.2117 12.674 5.1931 -10.339 11.1011 -13.5125 +563 2 13.668 11.9204 4.80624 6.1285 -2.92776 7.79567 +564 2 13.4681 12.7869 6.11335 2.67539 -7.97004 0.458585 +565 1 6.0506 7.06933 0.0406962 1.31452 -3.72946 4.6718 +566 2 6.04306 7.98784 18.9476 0.374235 14.6189 -4.65006 +567 2 5.24553 6.71887 0.435288 -0.866845 -3.58603 0.782556 +568 1 17.739 15.9899 15.0125 -12.5206 6.16285 -12.4036 +569 2 16.945 16.5161 15.03 -7.46495 5.1976 21.0221 +570 2 17.8264 15.955 14.0627 17.7161 -15.0875 -11.5838 +571 1 13.1794 1.00208 16.5735 3.37979 -5.34722 -6.70143 +572 2 14.139 0.860857 16.6169 -5.21536 -1.33728 6.50102 +573 2 12.8035 0.137283 16.3512 2.48828 2.22182 6.02943 +574 1 11.096 14.5828 7.22348 0.0189977 4.74793 7.83345 +575 2 10.4045 14.1614 7.73717 -8.54387 -1.14011 0.371667 +576 2 11.8979 14.1335 7.50232 3.58446 -6.30574 -4.63725 +577 1 17.5104 8.62105 2.08846 14.2737 4.97696 2.51664 +578 2 16.6904 8.42754 2.54903 -5.27316 -4.4343 -3.04137 +579 2 17.6167 7.98338 1.37729 -7.36397 -7.55614 -1.26172 +580 1 12.3515 7.96855 1.99107 6.37927 0.258975 7.77687 +581 2 12.1159 8.90068 1.90258 -3.43959 -5.51169 -5.98444 +582 2 11.9581 7.4701 1.26507 -2.67829 1.90847 0.988543 +583 1 11.8954 14.6159 10.3514 1.85125 4.19108 3.73581 +584 2 12.1615 13.856 9.81631 -7.50724 5.70574 2.33101 +585 2 10.9524 14.815 10.2079 9.27078 -9.38408 -0.682121 +586 1 6.88225 7.03081 15.6002 -4.063 -7.66118 -6.77733 +587 2 7.75096 7.17076 15.1857 -5.63662 2.89282 10.0227 +588 2 6.77779 7.6167 16.36 6.70206 0.515961 -5.66863 +589 1 8.00078 4.70171 13.472 -1.59283 -4.83357 -4.64481 +590 2 7.27623 4.81783 12.8396 5.32657 -1.99722 0.885811 +591 2 8.48998 5.527 13.4768 -0.383179 2.4117 0.469228 +592 1 13.3975 12.1709 14.2706 1.21587 3.44049 5.53322 +593 2 13.2724 11.2098 14.2197 -1.68144 4.93388 -3.39254 +594 2 13.8611 12.4606 13.4725 -0.646036 -5.76058 -0.123004 +595 1 14.8166 9.4384 7.29692 -7.31149 -4.84482 -6.71483 +596 2 15.6063 9.98387 7.39943 -3.2576 1.32409 4.65546 +597 2 14.0612 9.86586 7.70853 4.31514 4.68737 1.52589 +598 1 12.6657 17.0265 3.08863 -0.499632 18.4226 10.5493 +599 2 13.0409 17.4141 3.89779 -4.03665 -9.69042 -5.1428 +600 2 12.0457 17.7132 2.78031 5.51866 -13.6109 -0.0343421 +601 1 1.16791 7.14337 17.4519 -17.3777 -0.471365 -9.17207 +602 2 0.285968 6.88879 17.7816 4.71885 8.57951 0.206219 +603 2 0.996987 7.64547 16.6337 5.09703 -7.79381 5.85561 +604 1 12.7928 5.13809 15.6672 21.9233 -6.79759 1.12632 +605 2 13.5314 4.49934 15.6812 -12.3388 3.06691 0.377185 +606 2 13.2535 5.99313 15.6546 -7.1176 -2.71451 -0.771614 +607 1 2.50804 3.40102 5.01245 -9.19737 1.42964 37.6951 +608 2 1.85734 3.08405 5.69632 14.2768 7.06331 -19.9109 +609 2 3.04485 4.07021 5.49582 -10.9118 -9.07044 -17.2872 +610 1 8.33238 11.2579 13.4651 -31.1482 13.4197 6.60268 +611 2 8.24927 11.0816 14.4232 19.8118 -8.42601 -14.5581 +612 2 9.11403 10.9307 13.0113 5.91799 -11.9552 15.0186 +613 1 12.8978 1.37199 13.3367 -3.68795 11.8567 -21.2004 +614 2 13.3586 1.33808 12.4821 5.12584 -5.42725 10.3839 +615 2 12.3812 2.18266 13.2296 0.582289 -3.8456 10.447 +616 1 6.35916 13.6786 2.13932 11.022 -2.36774 12.7417 +617 2 5.81416 14.065 2.83164 -5.92624 2.48265 -4.44044 +618 2 6.97105 13.1303 2.64934 1.90703 -2.61302 -7.4669 +619 1 15.9256 6.59608 12.7788 -4.50753 -7.00075 -5.11208 +620 2 16.441 7.14613 12.1828 -0.0403293 3.27533 -1.15613 +621 2 16.337 6.66123 13.6439 3.64448 2.92523 3.21919 +622 1 16.8436 0.710185 9.59384 -10.8386 -3.59173 0.641976 +623 2 16.678 18.424 9.8391 7.1202 6.86076 -6.23598 +624 2 16.34 0.863872 8.77611 6.63769 -2.37412 0.960785 +625 1 6.14874 11.7365 8.37914 -9.33508 -33.9533 -7.34454 +626 2 5.23473 11.5355 8.67103 13.3879 7.28881 -1.35634 +627 2 6.50048 10.8558 8.08418 -3.72877 24.3898 8.07481 +628 1 2.86629 8.64627 0.414665 29.1459 -9.93647 1.24251 +629 2 2.37091 8.1673 18.3782 -14.09 11.8062 8.4924 +630 2 2.39345 9.32329 0.907466 -18.2396 -1.77699 -9.50941 +631 1 10.1496 10.4602 6.51654 2.68196 -4.3054 1.18084 +632 2 10.6351 9.79475 7.02051 -3.21697 0.687034 0.899044 +633 2 10.5797 10.4719 5.65285 -1.94715 4.18574 1.72512 +634 1 6.74842 15.6916 6.55665 -2.66838 16.8954 6.36263 +635 2 7.13132 16.1354 7.32023 -0.325366 -7.45035 4.57015 +636 2 6.8063 16.3799 5.88394 5.31174 -8.689 -7.83261 +637 1 6.45137 13.1469 5.60457 -4.49761 -5.86725 0.527716 +638 2 6.60666 13.9979 6.03098 2.95924 -2.27328 1.19215 +639 2 5.97977 12.5923 6.23705 2.74812 2.58161 1.74453 +640 1 16.8067 12.5538 9.81832 0.32671 -4.80998 5.18546 +641 2 16.9975 11.894 9.13199 -1.38663 9.72579 -2.40586 +642 2 16.8023 13.4365 9.43343 1.83869 -5.34542 -5.01893 +643 1 6.05747 2.94525 2.83457 1.69886 0.640591 -2.15275 +644 2 6.28227 3.83854 2.57267 5.15417 9.09864 3.82618 +645 2 5.67557 2.57416 2.03485 -2.61266 -9.3622 -0.552159 +646 1 10.8942 3.30264 3.28891 6.21412 -5.01644 3.41466 +647 2 10.2824 3.98758 3.58006 -2.01501 -0.119341 -5.67488 +648 2 10.543 2.90591 2.48434 -5.60317 1.35459 0.297545 +ITEM: TIMESTEP +30 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.7097 7.05343 17.9609 20.7509 -2.32452 -4.15205 +2 2 7.78893 6.94819 18.1674 -15.0431 -3.26874 3.90688 +3 2 8.91258 6.41114 17.2706 -4.14568 0.140094 0.745653 +4 1 18.6207 8.28878 6.84456 -10.9758 14.7568 -16.4597 +5 2 0.033254 8.12327 5.87995 7.78297 -6.3031 11.7942 +6 2 0.390602 7.58629 7.343 9.14113 -10.4614 1.3502 +7 1 8.4202 18.5906 6.81681 -12.3331 6.77681 2.70587 +8 2 9.32414 0.194792 6.65918 12.4366 2.53215 -2.1327 +9 2 7.89923 0.683074 6.46691 2.1768 -2.64942 -1.08929 +10 1 6.58134 1.82408 11.6823 -18.6778 6.99539 14.5251 +11 2 5.88329 2.28495 12.2086 12.5233 -11.9933 -14.8966 +12 2 6.20729 0.949756 11.4934 -0.484037 1.974 1.03676 +13 1 7.10261 5.71907 2.36398 18.2567 -30.46 4.77574 +14 2 6.748 6.26194 3.05915 -16.1408 13.0855 0.817955 +15 2 6.89353 6.07497 1.50557 -7.56713 14.4666 -6.71064 +16 1 16.2146 10.1912 16.1045 25.8326 -16.9059 -6.28167 +17 2 17.1924 10.2614 15.9892 -26.0275 4.96146 3.01812 +18 2 15.8649 11.0425 16.3511 -1.01593 12.6392 3.03555 +19 1 10.6309 14.9782 2.32852 5.54907 12.6484 -4.66534 +20 2 10.5683 14.607 3.21596 0.623447 -1.40903 0.430751 +21 2 11.0949 15.8303 2.43151 -6.58286 -12.6372 2.6945 +22 1 17.1592 8.25618 10.4876 -10.0218 -2.97818 8.46282 +23 2 16.7485 8.99843 10.9576 2.65758 -6.15573 0.24812 +24 2 17.9939 8.575 10.1448 6.84049 6.50961 -0.847785 +25 1 14.8275 15.8902 16.3678 -10.7483 8.55828 -7.5541 +26 2 13.911 16.2262 16.382 8.40977 -5.5752 2.0788 +27 2 14.9328 15.3229 17.136 -2.68587 0.983086 7.72287 +28 1 12.1445 13.398 0.450021 7.16446 -9.51802 2.88894 +29 2 12.0254 13.4023 18.1304 -4.57533 9.09159 6.34311 +30 2 11.5749 14.0284 0.911779 -3.72154 -0.858053 -5.79964 +31 1 9.27791 5.43254 4.03115 12.5872 2.27984 -15.9713 +32 2 8.88042 5.04351 4.80522 -11.7175 -1.93285 8.71688 +33 2 8.63164 5.36398 3.31053 -0.238489 1.95718 4.1093 +34 1 1.81582 4.23406 11.6392 3.52665 -33.0533 9.77708 +35 2 1.78778 5.15359 11.8657 -3.54286 18.5189 3.84305 +36 2 2.12638 3.75505 12.4373 -4.00166 7.6753 -17.1576 +37 1 1.99877 6.82017 8.35649 4.97761 -1.46296 10.7796 +38 2 2.31944 7.23424 9.17304 -0.0326511 4.09138 -10.3959 +39 2 2.07937 5.88268 8.56766 -7.36821 -1.33929 -3.79841 +40 1 5.395 4.41162 7.94446 4.05063 -3.43427 6.53634 +41 2 5.41133 3.44966 7.94196 6.73946 -4.4132 0.768998 +42 2 4.74595 4.62804 7.28165 -7.35272 12.6119 -8.90882 +43 1 3.28409 2.93052 17.527 4.91883 3.31559 -8.51102 +44 2 3.97895 3.44036 17.0791 -2.08356 -9.03714 -1.68785 +45 2 2.70652 3.59221 17.9099 -2.28402 5.9437 7.00724 +46 1 7.47067 5.28165 6.09824 -7.47353 5.76211 -2.63966 +47 2 7.88561 6.05707 6.46631 15.843 7.70036 2.30241 +48 2 6.86027 5.05727 6.79609 -9.98425 -16.5426 3.24835 +49 1 9.77462 7.02047 11.9927 -3.16333 0.34511 -3.92757 +50 2 10.3836 6.39122 11.588 -5.90607 3.51948 -2.51732 +51 2 9.0529 7.19715 11.3548 12.4276 -3.26368 6.69514 +52 1 14.0466 3.57679 8.07144 18.6703 -0.348541 19.5758 +53 2 13.8937 4.22019 7.39343 -5.64007 13.0869 -9.16622 +54 2 14.611 4.0279 8.7381 -15.3074 -10.3909 -10.441 +55 1 4.67183 17.2138 3.98342 -17.1629 -17.7927 10.2823 +56 2 5.57476 17.4036 4.21567 13.953 12.775 -5.74716 +57 2 4.34342 17.7474 3.25626 2.59666 4.69733 -2.98879 +58 1 16.5112 16.6016 10.1232 -22.4077 14.5184 19.5552 +59 2 15.797 16.9077 10.7255 16.9762 -11.2391 -6.18282 +60 2 16.019 16.127 9.45142 2.29692 -6.2585 -6.10264 +61 1 1.96965 4.87893 0.40906 -10.7697 -8.55226 -4.93465 +62 2 2.66061 5.27529 0.941341 5.5274 3.49831 6.88318 +63 2 1.47511 5.62215 18.6951 6.32177 2.44726 -2.78863 +64 1 11.7331 13.3335 16.3023 -6.06186 -8.167 -3.78825 +65 2 11.2597 12.4992 16.3612 -10.498 -1.32756 10.0093 +66 2 12.2577 13.1697 15.5177 8.21427 7.2284 -4.69488 +67 1 10.121 11.0486 16.9167 -7.88764 10.2638 -1.90592 +68 2 10.5124 10.1783 16.9786 2.49636 -9.86729 -0.127492 +69 2 9.16626 10.9164 16.816 6.71354 -1.99355 -1.80005 +70 1 11.7161 17.4964 13.4564 0.653858 7.10726 11.4031 +71 2 12.4343 17.1488 12.9211 3.60089 1.57548 -4.57497 +72 2 11.8646 18.4589 13.5472 2.97554 -11.89 -7.13537 +73 1 6.3779 9.31416 12.2259 -8.95234 15.1635 22.3379 +74 2 6.77463 8.98312 11.4273 14.2971 -1.19702 -8.86117 +75 2 6.96666 9.97806 12.6372 -2.9053 -11.0825 -10.5803 +76 1 16.2282 12.7644 2.6938 13.255 22.6007 -2.42149 +77 2 17.0484 13.1981 2.39924 -4.54016 -10.6437 3.48813 +78 2 15.6471 13.522 2.85837 -6.5992 -7.46489 -1.32569 +79 1 0.640508 12.5852 5.88727 21.753 -1.83143 4.54161 +80 2 0.997304 12.3975 5.01963 2.04371 1.22983 -7.11515 +81 2 18.3646 12.7399 5.72186 -19.0302 3.73655 0.683884 +82 1 5.21387 16.4194 18.454 4.66732 -1.11443 8.72996 +83 2 5.89359 15.806 18.1817 0.824082 -8.56943 -13.0935 +84 2 5.59435 16.7978 0.603858 -5.48698 7.00748 3.62952 +85 1 0.548987 7.64401 4.10842 0.670348 4.32997 2.73018 +86 2 18.6015 7.92625 3.40384 -3.24873 3.72744 -1.92559 +87 2 1.36738 8.12724 3.94642 3.53853 -5.18785 -2.83474 +88 1 3.12734 8.93117 6.50347 30.4123 1.43415 3.20415 +89 2 3.68489 8.55498 7.21169 -11.4249 4.27745 -10.9708 +90 2 2.23185 8.74841 6.74202 -19.2185 -4.73256 7.28786 +91 1 7.31515 10.3274 16.2171 -7.5998 2.86538 3.08356 +92 2 6.58991 10.5191 15.6248 2.07633 0.375924 -7.53004 +93 2 6.86928 10.3012 17.0718 3.58834 -2.41696 5.50844 +94 1 11.1056 1.03439 5.00906 5.66297 2.87297 -9.25474 +95 2 11.3082 1.81468 4.47889 -2.42802 6.95123 8.17266 +96 2 10.7866 0.43271 4.33294 -5.36858 -10.0003 1.63315 +97 1 4.38851 2.75082 13.2055 -1.16421 16.6802 -23.4007 +98 2 4.78143 3.22961 13.9394 0.315345 -9.27332 13.6616 +99 2 4.20912 1.83275 13.4212 4.21877 -6.70893 11.8835 +100 1 8.39225 10.0828 1.81263 -0.204034 19.0364 -5.60934 +101 2 8.35289 10.7959 2.47026 -1.38438 -3.08289 -2.87504 +102 2 8.81547 9.35618 2.25702 3.41266 -13.1645 6.66357 +103 1 10.4926 1.73671 15.571 11.1439 -7.64614 -12.2914 +104 2 11.3949 1.40928 15.4244 -6.59208 6.73213 11.009 +105 2 10.2461 2.06593 14.699 -6.9068 1.71228 -0.826453 +106 1 2.72763 12.9186 7.78215 1.53907 -1.41162 9.17357 +107 2 3.36352 13.5565 7.43734 -3.21302 -0.65885 -4.12251 +108 2 2.22004 12.5809 7.03913 -2.76352 5.50699 -3.09439 +109 1 3.68558 11.672 5.21041 4.08504 4.36046 -3.38247 +110 2 3.45481 10.9554 5.79468 0.598863 -9.40064 6.30918 +111 2 2.92113 11.7973 4.6466 -2.33635 3.52119 -7.07475 +112 1 6.80415 14.4796 16.8864 5.34146 -11.2852 2.95693 +113 2 7.68462 14.091 16.8709 -3.70601 4.15103 0.993665 +114 2 6.49099 14.4407 15.9783 -2.62919 9.78665 -2.68056 +115 1 14.176 14.5561 3.39307 -12.5209 -3.15767 3.59597 +116 2 13.6245 15.3467 3.3085 5.15733 -4.43597 -5.06132 +117 2 13.635 13.92 3.89178 10.6994 6.10439 -0.0738324 +118 1 8.31018 18.1523 16.0453 25.0942 2.73084 1.98444 +119 2 8.89462 17.4796 16.3723 -6.95894 -25.3404 9.38217 +120 2 8.98968 0.119946 15.7574 -11.3153 21.4924 -7.69748 +121 1 4.73581 1.63729 4.92804 -12.581 -10.4736 11.5054 +122 2 3.83953 1.97889 4.8343 1.42607 1.89675 3.67103 +123 2 5.27039 2.18299 4.37483 11.2234 12.2757 -18.577 +124 1 15.0504 12.7475 16.4383 22.4341 -19.9388 -26.396 +125 2 14.708 13.1949 17.1966 -19.6268 9.49299 12.0559 +126 2 14.4413 12.6723 15.6738 0.429593 5.89098 19.3668 +127 1 15.7794 18.4162 16.8297 -23.8108 0.224717 -24.365 +128 2 16.2557 18.6157 17.6209 13.9809 -1.68 17.1984 +129 2 15.4229 17.5182 16.8969 9.44127 2.10519 2.83182 +130 1 1.1656 1.1613 16.5455 9.88565 -3.33075 -8.05438 +131 2 1.89055 1.78579 16.6066 9.02992 -0.102422 -1.61706 +132 2 0.673214 1.35844 17.3295 -13.4515 3.62078 11.8035 +133 1 18.1028 4.54571 15.8941 -4.73113 6.48399 7.96005 +134 2 18.5013 4.04336 15.196 5.27298 -10.1152 -10.2677 +135 2 18.7433 4.58481 16.606 1.22293 0.259147 -1.01212 +136 1 12.236 16.9836 16.146 14.9412 3.5391 -27.9779 +137 2 11.6416 16.3841 16.5672 -17.548 -8.54782 13.2608 +138 2 12.0887 16.8479 15.1863 -0.907912 9.23395 13.7712 +139 1 15.9498 2.53257 18.0253 10.6473 -13.6828 8.83411 +140 2 15.5627 3.24781 18.526 -5.22656 12.7326 -1.10284 +141 2 15.751 2.68965 17.0989 -3.04742 3.76351 -4.61681 +142 1 6.7038 13.8197 10.2271 2.9338 -17.2727 -3.34939 +143 2 6.61667 13.5512 11.144 -2.24755 5.72821 7.93099 +144 2 6.68776 12.9653 9.76874 -1.43812 10.35 -6.56898 +145 1 10.1318 18.2649 2.7724 -13.411 -9.16786 2.85058 +146 2 10.3828 0.244178 2.09267 2.54842 10.4954 -6.81354 +147 2 9.19143 18.056 2.59362 16.7762 1.59207 3.74676 +148 1 2.99108 17.7409 6.10283 23.0954 -1.76337 16.2177 +149 2 2.19234 17.7622 5.58671 -8.31269 -3.84851 -15.8536 +150 2 3.76803 17.7869 5.51609 -16.1123 2.00349 -4.76697 +151 1 12.5756 16.9274 7.99763 -5.18448 9.92793 0.0594024 +152 2 11.7822 16.4009 7.94219 -1.30832 -15.7704 -9.09049 +153 2 12.3073 17.5896 8.63909 10.7698 6.45321 6.22995 +154 1 14.8838 15.2691 8.24901 11.9288 7.15592 -19.4456 +155 2 14.3219 16.0313 8.11935 -17.9047 1.82161 10.6012 +156 2 15.419 15.3185 7.43747 0.964457 -9.38205 7.76842 +157 1 17.6242 18.2515 0.369787 17.475 26.3316 2.73311 +158 2 18.5101 17.9713 0.0958777 -8.0951 -12.2782 0.813683 +159 2 17.7821 0.518901 0.686034 -9.22006 -13.9572 -3.22273 +160 1 0.867554 10.3913 1.38534 13.3292 31.3771 -20.1166 +161 2 0.0708789 9.90853 1.49908 -23.2341 -17.8443 11.3974 +162 2 0.609768 11.125 0.785047 6.92113 -8.95227 10.8017 +163 1 1.63658 12.2225 3.36866 -7.99561 -17.8946 -31.9552 +164 2 1.35203 11.5128 2.74742 7.334 6.03534 21.6261 +165 2 1.63695 12.9742 2.77054 4.15295 9.67724 10.1418 +166 1 0.571199 17.2371 4.87124 -14.5407 6.59112 32.0774 +167 2 -0.059088 17.9662 4.92138 6.12201 4.50556 -13.0577 +168 2 0.445901 16.8548 5.75927 11.2459 -10.7393 -14.745 +169 1 1.10756 0.954018 9.42478 -6.01064 0.927768 -12.2971 +170 2 1.20282 0.614567 10.324 -1.80966 -3.76099 -1.37067 +171 2 0.239583 0.659806 9.09473 9.24115 0.27684 10.6776 +172 1 16.7657 2.33783 13.2856 -4.77092 -12.7415 18.4331 +173 2 16.9235 2.53629 12.3736 4.43968 6.32108 -18.3535 +174 2 16.5017 1.40258 13.3145 0.84997 6.98888 1.09187 +175 1 2.55595 15.84 12.1915 -9.99296 7.89206 -20.2214 +176 2 3.13585 15.4219 12.8083 9.49953 -6.79049 14.4751 +177 2 2.92245 15.6515 11.3148 -0.922807 -1.51117 1.32599 +178 1 16.4223 15.613 5.98575 -3.71667 -18.1819 11.7841 +179 2 17.3247 15.5921 6.33835 -0.216171 6.69275 -4.6749 +180 2 16.2529 16.4332 5.52058 8.23488 6.69239 -4.77655 +181 1 5.80627 5.05529 11.7835 2.20346 1.03406 8.57972 +182 2 5.47099 5.61389 12.5063 0.21977 1.29573 -10.4635 +183 2 5.43215 4.18052 11.9366 -3.48089 3.11082 -1.53573 +184 1 15.1897 4.8564 0.727292 -5.49239 9.65996 -2.72664 +185 2 15.2051 4.71263 1.67299 -4.1535 -7.09946 8.01526 +186 2 14.3467 5.30742 19.2217 7.5675 -5.77492 -4.69919 +187 1 16.3443 16.3423 2.09898 -10.6702 -0.501744 21.7899 +188 2 16.0343 16.7391 2.94116 7.72577 -10.997 -12.8868 +189 2 16.4832 17.1019 1.54751 7.961 8.6491 -12.4493 +190 1 0.271558 4.86315 3.80356 2.16636 -31.8967 4.70784 +191 2 0.500225 5.77685 3.71679 7.2244 19.9811 4.59738 +192 2 1.02077 4.40389 4.23265 -9.838 12.5034 -4.93629 +193 1 2.94659 15.0442 15.0679 0.642608 -6.50925 -4.27186 +194 2 2.75789 14.5701 15.8868 0.637625 5.4096 6.54553 +195 2 2.48063 15.8876 15.1248 -0.665005 -3.22304 2.52721 +196 1 1.13823 14.625 9.55769 -40.6641 2.98648 23.3687 +197 2 1.89308 14.4183 9.03602 24.2615 -17.8348 -5.78778 +198 2 0.899054 13.8694 10.146 16.149 11.9497 -18.7143 +199 1 13.6328 16.6228 11.5317 -8.77554 -4.828 10.6654 +200 2 13.2136 17.4084 11.1616 -1.58446 0.630618 -8.00902 +201 2 13.0391 15.8864 11.302 7.59245 3.60181 -7.14688 +202 1 4.70114 1.47286 0.734685 -3.14847 1.30924 1.42089 +203 2 4.10181 2.05657 0.255283 4.3012 0.912352 -3.9516 +204 2 4.12143 0.893804 1.23429 -1.01367 -7.44934 0.356301 +205 1 1.44259 18.5254 11.8725 4.87725 -20.5249 2.38925 +206 2 1.2982 0.329643 12.7089 -1.92821 4.76162 2.3937 +207 2 1.66413 17.5975 12.0994 -0.659414 17.7173 -3.45023 +208 1 11.5206 10.1171 4.06393 -3.80452 1.00663 -6.51606 +209 2 11.2843 10.553 3.23019 1.0155 -1.19537 2.23558 +210 2 12.4827 10.1039 4.08159 3.36054 1.41703 2.51077 +211 1 8.33991 12.1729 3.71569 5.40649 2.32091 -9.4304 +212 2 9.08268 12.7024 4.00206 12.7546 1.78956 -5.29094 +213 2 7.80528 12.1916 4.49536 -21.4073 -3.06625 11.8611 +214 1 14.3677 4.01314 3.28101 5.46562 4.88363 2.56432 +215 2 15.0857 4.19963 3.89805 0.543674 -3.28085 4.74869 +216 2 13.622 4.5498 3.58084 0.572713 -1.66955 -3.63784 +217 1 5.59145 1.71061 7.51389 3.0333 8.44076 -17.8773 +218 2 4.93757 1.09228 7.83941 -4.88752 -5.30351 6.58254 +219 2 5.37448 1.80426 6.56172 4.34195 -4.37145 14.4788 +220 1 17.8887 1.09435 4.8754 -0.773263 0.600717 5.02725 +221 2 18.623 1.41887 4.35928 5.70444 0.114988 -11.5441 +222 2 17.8389 1.7231 5.59879 -7.43418 -0.321368 4.00301 +223 1 6.81825 9.41317 4.48156 7.11204 -1.13267 15.9283 +224 2 6.84118 9.52277 5.44603 -5.88151 0.934362 -6.29355 +225 2 7.74851 9.26985 4.27279 -2.06614 -3.64671 -7.13223 +226 1 2.66566 14.925 1.97184 3.43761 -5.8072 22.4208 +227 2 3.31024 14.6851 2.65976 -11.6222 2.95672 -3.26291 +228 2 3.19272 14.9753 1.1906 5.92571 0.162325 -19.2981 +229 1 17.2917 12.9099 13.1468 13.6904 -32.8575 1.82925 +230 2 16.4305 13.254 13.3667 -5.78742 18.0954 -2.54799 +231 2 17.8833 13.5932 12.8229 -8.84805 15.1913 2.15275 +232 1 14.9839 10.5629 1.38454 25.7264 11.2091 10.263 +233 2 15.6084 11.2587 1.71974 -19.4135 -18.6888 -7.72567 +234 2 14.1549 11.0026 1.25075 -10.8149 6.915 -1.22185 +235 1 5.70372 6.84607 4.55662 8.80438 8.80025 -0.823305 +236 2 6.10735 7.7373 4.58073 -7.50282 -10.5851 -1.04914 +237 2 6.32636 6.24858 4.99 1.7616 -0.154003 4.43374 +238 1 8.04871 8.29405 10.2754 3.94684 3.34606 -22.4081 +239 2 8.71637 8.94856 10.0317 -1.03323 4.34225 9.84614 +240 2 7.78699 7.97842 9.39774 -4.16124 -6.72066 12.7971 +241 1 13.4913 18.3469 5.77892 -1.26098 13.9384 -13.7404 +242 2 12.815 0.368504 5.57583 1.14564 -3.93427 -2.76608 +243 2 13.0908 17.8361 6.47463 -1.65231 -11.4802 12.6171 +244 1 0.227007 2.59645 0.141675 -14.0496 12.7254 8.33212 +245 2 17.9751 2.93781 18.665 -4.73692 -13.8452 -6.2234 +246 2 0.694599 3.38298 0.431909 14.3746 0.669884 0.426623 +247 1 12.7219 11.0238 9.75183 49.8657 -12.692 14.413 +248 2 11.8223 11.0616 9.49871 -31.5247 -8.5727 -6.88909 +249 2 12.9406 10.0926 10.0008 -12.7634 16.4478 -4.29644 +250 1 0.765495 12.2256 11.092 -6.27201 -3.92882 -21.6672 +251 2 18.4439 12.3344 11.0429 5.26844 -2.50397 8.5312 +252 2 1.08097 12.384 11.9788 -3.27397 5.59862 9.72518 +253 1 5.06534 7.27352 13.4491 9.82463 3.8805 6.07585 +254 2 5.60445 7.97165 13.048 -4.44492 -2.76176 -4.56894 +255 2 5.50693 7.14172 14.2991 -3.01503 -3.24863 -0.495805 +256 1 1.24722 6.90803 11.85 29.2977 26.916 27.8288 +257 2 0.522094 7.24638 11.3513 -16.2758 4.78156 -11.2742 +258 2 1.67283 7.72942 12.2344 -11.891 -29.9717 -16.3043 +259 1 15.4903 9.51892 12.3126 7.40517 -6.095 -16.4028 +260 2 15.1231 10.4002 12.2744 -2.67202 9.46709 6.64342 +261 2 15.3464 9.12903 13.1709 -3.09066 3.82816 8.99587 +262 1 16.6298 12.8631 5.48891 1.11523 -3.92575 5.75418 +263 2 16.4995 13.8048 5.46845 -2.55881 16.2829 11.3267 +264 2 16.4805 12.6501 4.57692 -1.87933 -15.1854 -15.6508 +265 1 6.21094 9.97472 0.0957231 23.6487 -5.34392 2.82943 +266 2 5.60453 10.4038 0.703481 -3.26342 3.61778 2.3496 +267 2 7.09538 10.0231 0.521798 -18.1891 -1.30215 -0.820391 +268 1 12.348 6.08762 4.05307 2.0614 24.7942 -10.4953 +269 2 12.1492 6.85087 3.46448 11.8353 -14.4305 6.54315 +270 2 11.534 5.60454 4.05688 -13.4451 -11.2489 2.03158 +271 1 0.182227 12.8112 0.197519 7.97213 -0.157956 2.72486 +272 2 0.124577 13.5143 0.856815 -1.71897 -0.134619 0.137441 +273 2 18.3975 13.1734 18.0617 -3.09196 -0.84285 -5.0356 +274 1 3.77998 18.5905 8.57799 -18.8802 5.92516 7.26956 +275 2 3.52251 17.9827 7.88131 5.13558 -0.560148 -6.56591 +276 2 2.92387 0.359522 8.79319 10.0752 -0.462424 4.43469 +277 1 7.44275 17.2901 4.46744 -21.5086 -34.4409 7.51913 +278 2 7.83961 18.0981 4.73248 10.1677 27.4444 -0.194329 +279 2 7.33826 17.2675 3.51576 6.23588 9.30645 -6.08156 +280 1 9.24103 17.0711 12.2479 -19.3743 11.7076 -0.715804 +281 2 9.17102 16.3949 11.5719 7.91635 -8.00505 -0.934966 +282 2 10.0835 16.9964 12.6894 10.2718 -1.4174 0.528472 +283 1 13.295 12.9281 7.96455 10.8524 35.2373 8.53109 +284 2 13.4175 12.2933 8.66577 -5.31299 -13.0614 2.94334 +285 2 13.7676 13.7325 8.27776 -0.249345 -13.5851 -11.5496 +286 1 14.9473 2.96516 15.3472 -8.56764 -6.90335 7.41648 +287 2 14.4704 2.13858 15.1989 -5.86972 7.46703 2.11397 +288 2 15.5773 2.99488 14.6333 9.67131 3.29159 -8.66831 +289 1 9.8733 15.5399 16.9999 -1.15808 -3.26391 2.43146 +290 2 10.4067 14.7753 16.7398 -3.17357 -1.97936 0.56939 +291 2 9.29049 15.2638 17.7267 6.50431 4.19029 -1.43758 +292 1 11.3155 8.30103 16.5489 -8.97523 -12.184 6.64215 +293 2 10.5995 7.86385 16.0596 7.08532 7.34183 -0.412451 +294 2 11.4953 7.67267 17.2664 2.19784 9.25982 -2.90547 +295 1 3.86136 18.202 16.7472 -0.00540616 -19.6914 -20.2162 +296 2 4.27115 17.4628 17.2262 -1.12743 11.6131 4.05136 +297 2 3.85436 0.333712 17.2887 2.36829 10.2975 15.3313 +298 1 2.18996 4.14488 8.93819 0.886129 3.08448 -7.12661 +299 2 3.10445 4.02058 8.72725 13.9566 -1.85365 -12.2229 +300 2 2.19804 3.9794 9.87086 -10.6985 1.40109 20.9797 +301 1 9.87077 10.3617 9.71962 10.1113 -1.13074 11.4426 +302 2 9.57245 11.1887 9.34333 -7.01747 6.00246 -6.1834 +303 2 10.1269 10.5679 10.6319 -2.96085 -6.85282 -1.29137 +304 1 9.72151 0.827202 10.8565 -16.8019 0.79505 -1.6906 +305 2 9.17924 18.7332 11.1654 13.4836 -3.87865 6.80866 +306 2 9.14124 1.21724 10.1941 6.30814 7.82285 -3.72399 +307 1 9.21217 15.15 10.2242 6.46373 1.33184 2.55262 +308 2 8.76537 15.794 9.67699 -2.80645 8.81337 -5.09524 +309 2 8.53339 14.5081 10.4276 -6.91387 -6.36492 -2.48134 +310 1 0.979873 9.39617 10.3168 -32.1534 32.2854 2.26584 +311 2 1.01417 10.3672 10.3328 -11.1793 -7.1298 6.70775 +312 2 1.8685 9.20872 10.1515 40.6499 -19.8378 -9.87175 +313 1 16.9127 4.85919 8.18774 -4.59801 12.0977 -12.3954 +314 2 16.2737 5.53573 8.4435 0.928859 1.2732 2.05393 +315 2 16.9639 4.27263 8.93179 4.52425 -11.0836 8.47724 +316 1 14.6737 14.709 0.318185 15.3338 2.15239 -13.9805 +317 2 15.2295 14.9726 1.0606 -1.701 5.56475 -1.20644 +318 2 13.8551 14.4222 0.702232 -12.5496 -7.63291 5.74768 +319 1 3.57822 11.0521 9.58832 7.05767 -0.848593 3.86503 +320 2 3.70772 11.5491 10.4084 -2.82358 -5.49605 1.13538 +321 2 3.0796 11.6369 9.01245 -0.492053 5.16034 -4.32733 +322 1 11.1043 10.8166 1.33994 -11.5702 -13.9866 8.70354 +323 2 11.3928 11.6085 0.903197 7.06397 14.5046 -5.44138 +324 2 10.1649 10.7312 1.10986 7.36828 -2.13735 3.91294 +325 1 13.1846 7.09882 12.8318 18.6724 6.28095 -0.937746 +326 2 14.1536 6.98642 12.9472 -16.4658 1.64828 -3.93553 +327 2 12.8311 6.20921 12.7949 -4.05904 -6.33012 1.01947 +328 1 9.62724 1.89857 0.976269 -5.84048 -4.71512 -19.854 +329 2 8.85605 1.47112 0.556627 5.981 10.7585 7.84687 +330 2 10.1714 2.22507 0.238723 -1.51496 -2.73206 9.47681 +331 1 10.5937 13.5214 4.66199 3.2234 0.0339744 -7.62843 +332 2 11.4486 13.114 4.51461 3.39436 -8.72009 -0.849353 +333 2 10.7191 13.8974 5.52846 -5.55452 9.94363 9.85641 +334 1 14.3279 1.73837 10.9221 -6.80645 -20.6925 1.76137 +335 2 15.1234 1.41881 10.4767 1.97621 6.90305 1.731 +336 2 14.3743 2.69243 10.9875 9.24527 6.91542 -4.56959 +337 1 14.6348 12.3447 11.7069 0.143663 -8.85162 -7.69369 +338 2 15.3924 12.4169 11.1267 15.8185 6.23005 6.53749 +339 2 13.9779 12.0599 11.0796 -19.2308 -4.32411 1.56042 +340 1 8.24345 5.06862 9.81236 -2.43519 -19.796 -15.4196 +341 2 7.42328 5.28077 10.2334 -12.2119 11.2175 13.6651 +342 2 8.03366 4.19231 9.43495 14.0834 8.03075 2.78805 +343 1 1.55958 16.8456 18.3509 0.293915 -24.903 24.1992 +344 2 1.74487 17.2231 17.5072 8.4457 6.47265 -18.7434 +345 2 1.95964 15.9468 18.3277 -12.6492 15.8955 -3.16542 +346 1 1.46885 17.2295 15.3261 -41.9231 18.9429 7.61422 +347 2 1.60163 18.0716 15.7975 2.88525 -7.29411 -7.90761 +348 2 0.471438 17.1304 15.2829 39.2238 -5.53287 -0.382895 +349 1 3.69895 5.65007 6.13962 5.67498 -13.7905 -4.71311 +350 2 3.08621 6.15365 6.67268 -1.79156 10.6243 5.04455 +351 2 4.29662 6.26435 5.6935 -4.62364 1.91275 -0.121461 +352 1 12.3686 9.4572 14.1916 2.50325 4.1373 0.835901 +353 2 12.6534 8.64397 13.7789 7.43403 -8.19142 -7.10693 +354 2 12.2431 9.18714 15.1032 -3.68368 1.41273 6.14038 +355 1 4.03462 15.2828 6.91278 -20.0144 -6.90546 3.84648 +356 2 3.57361 16.022 6.48562 4.0204 -1.30953 4.99773 +357 2 4.97214 15.427 6.85986 17.0804 8.85667 -5.89205 +358 1 0.596937 8.57007 14.913 -2.82207 -2.34568 11.0967 +359 2 0.589839 9.51288 15.1099 0.171131 2.88226 -3.41975 +360 2 1.22453 8.45469 14.2015 6.96836 3.95738 -3.73783 +361 1 12.9772 8.31295 10.3135 -4.52981 3.4147 9.81026 +362 2 13.748 7.88649 9.95158 7.10588 -4.96512 -13.4998 +363 2 13.0418 8.05063 11.2408 -7.87478 3.04011 -0.538852 +364 1 15.3081 7.67138 3.5266 23.4653 37.2808 -10.5735 +365 2 14.5495 7.31548 3.08478 -13.5361 -20.5278 3.76808 +366 2 15.7097 7.21489 4.26906 -13.5998 -13.5183 6.32814 +367 1 17.3139 6.67347 0.0519528 8.75828 -11.5188 0.32751 +368 2 16.922 5.81479 0.236083 -1.36263 0.235584 3.31968 +369 2 16.5542 7.20912 18.4844 -8.7655 12.4237 -8.09845 +370 1 8.86065 6.91878 7.81669 10.1209 17.2302 -14.0365 +371 2 9.80786 7.17641 7.77744 -16.0922 -4.42618 4.57681 +372 2 8.74795 6.24147 8.48473 3.77983 -6.9476 8.96536 +373 1 12.3541 0.627989 1.20673 7.59332 -4.64776 2.86492 +374 2 13.2579 0.528374 1.53727 -3.51801 6.0046 2.76074 +375 2 12.2851 18.632 0.498856 -2.53947 0.382583 -4.14536 +376 1 5.64549 15.138 14.5235 -4.10456 -30.421 5.78959 +377 2 4.73353 15.1769 14.8501 2.72532 6.49481 -6.12593 +378 2 5.9656 16.0086 14.3294 1.76375 18.5631 -6.42604 +379 1 3.85619 6.49135 1.72458 1.34418 -5.76632 6.1851 +380 2 3.4082 7.28863 1.44351 -4.61345 8.91678 -8.73454 +381 2 4.04036 6.67595 2.65567 -1.04596 -4.79787 -3.17499 +382 1 3.88128 11.6181 12.3021 -8.90147 -4.54474 -0.675722 +383 2 4.76839 11.88 12.5585 3.1774 6.51538 0.922611 +384 2 3.25574 12.2257 12.7332 9.80963 -6.2977 -1.14662 +385 1 5.41097 3.86243 15.8619 7.77498 -26.7447 2.47729 +386 2 6.19051 3.2555 15.8125 -22.34 13.8462 -4.82428 +387 2 5.75732 4.74289 15.8731 9.06733 16.771 0.375084 +388 1 14.4275 10.3077 4.42737 -15.4583 -1.2468 24.8449 +389 2 14.4136 9.7945 5.25584 5.65105 6.60384 -6.24763 +390 2 14.7139 9.69599 3.76155 7.16087 -8.52398 -12.4829 +391 1 7.87022 17.3652 9.18307 -6.55512 0.129027 -0.760847 +392 2 7.04604 17.5698 9.62158 -5.94597 -4.85201 9.5143 +393 2 7.92762 18.0395 8.50377 8.60962 -1.46955 -8.60251 +394 1 4.50919 14.4633 3.94747 -3.26277 6.69504 -13.1744 +395 2 4.44326 15.3745 4.23469 1.61374 7.68172 -2.63862 +396 2 4.73121 13.9745 4.72809 3.38773 -13.7326 11.5154 +397 1 14.2916 7.39166 15.7799 -19.0102 -0.643935 -4.97281 +398 2 15.227 7.28492 15.6956 21.3172 -2.59108 -3.06 +399 2 14.1661 7.73476 16.6606 0.966931 5.43289 9.36717 +400 1 2.93597 18.2496 1.90178 2.72474 -19.4407 -7.90163 +401 2 2.41137 17.5137 1.50762 13.3283 19.165 4.04527 +402 2 2.31568 18.912 2.18531 -12.4791 7.28301 8.56329 +403 1 7.97625 1.60842 4.55987 -20.0747 11.2227 -5.58284 +404 2 7.40672 2.18903 4.02942 -3.00667 -10.939 3.58357 +405 2 8.83426 1.86357 4.26417 23.6954 -1.42515 0.234182 +406 1 2.55973 14.139 17.7235 4.4947 4.4122 -3.81652 +407 2 1.9869 13.4419 18.0532 -4.8721 0.171095 2.94118 +408 2 3.45785 13.8729 17.9629 -0.333069 -3.9381 0.822902 +409 1 0.778432 1.72633 13.8806 -27.0748 -1.51039 10.7449 +410 2 0.840363 1.33642 14.7677 3.59517 6.80992 -7.55552 +411 2 18.4512 1.86919 13.7675 25.1129 -0.50251 -4.23703 +412 1 4.5218 18.6217 13.9311 -26.2208 4.76485 6.31935 +413 2 5.44026 18.4597 14.0857 18.6112 -6.32709 -3.49173 +414 2 4.08533 18.4032 14.7706 3.39103 3.57256 -5.13956 +415 1 7.0966 0.590139 18.3583 40.0867 -7.03194 -16.485 +416 2 7.43029 0.218977 17.5038 -14.1267 7.45313 19.238 +417 2 6.15491 0.497007 18.3797 -17.6926 4.43938 -0.268226 +418 1 16.0869 18.4184 14.0665 12.1783 12.0602 19.9903 +419 2 15.2602 18.093 13.7757 -22.8702 -12.1677 -15.3509 +420 2 15.9307 18.6351 14.9998 9.22594 -1.26981 -3.76068 +421 1 10.0615 4.5254 16.2644 17.4965 34.4304 -0.599412 +422 2 10.952 4.96419 16.2693 -15.2122 -21.3498 0.578373 +423 2 10.2001 3.58581 16.3272 5.99955 -12.591 -1.94777 +424 1 15.8874 17.8488 4.44366 26.9944 -8.8935 -8.85545 +425 2 16.3583 18.6921 4.41154 0.375294 -2.3726 2.41747 +426 2 14.9936 18.0388 4.65191 -27.7242 10.9512 11.1951 +427 1 6.97313 17.3837 13.7492 -14.8371 0.980348 6.17816 +428 2 7.33935 17.5289 14.6184 6.46616 5.40365 9.01508 +429 2 7.73032 17.2786 13.1826 8.79779 -2.98362 -9.94394 +430 1 13.295 6.50203 6.69495 9.53809 17.2257 -14.0038 +431 2 14.0496 7.07319 6.46986 -0.499105 -8.31015 13.7378 +432 2 12.8724 6.42857 5.83749 -8.85952 -9.05901 -3.70628 +433 1 7.73318 2.36184 9.23357 -5.82839 -0.191385 25.6357 +434 2 7.13515 2.2598 10.0003 13.8878 3.27143 -3.38814 +435 2 7.19146 2.08044 8.50905 -8.01798 -3.82737 -18.8349 +436 1 15.1683 14.8678 13.6621 4.32457 -5.24538 6.92634 +437 2 15.0117 15.191 14.5524 1.96766 -1.10504 5.54809 +438 2 14.4461 15.1877 13.1369 -6.78809 4.58671 -11.3713 +439 1 9.33811 8.31525 3.72912 -3.71623 14.6513 -1.76526 +440 2 10.1422 8.72537 4.07444 1.32163 -4.04075 -0.39549 +441 2 9.3744 7.3721 3.88081 4.66337 -7.69389 3.46587 +442 1 17.73 13.5264 16.4473 3.62887 -10.5665 6.33517 +443 2 16.8053 13.2497 16.375 1.67263 6.91521 -3.1024 +444 2 17.8249 14.3621 15.9879 -5.28625 7.64018 -4.86126 +445 1 4.99014 10.6392 2.69296 -11.8842 10.0017 7.67541 +446 2 5.62836 10.2105 3.25699 12.1385 -6.17254 3.53336 +447 2 4.64978 11.3543 3.2597 0.304061 -9.29163 -9.90123 +448 1 3.7356 8.34279 10.2382 -0.81373 18.9096 -12.0232 +449 2 3.86658 9.26506 9.94102 0.197912 -10.4595 0.115104 +450 2 3.49052 8.44407 11.1547 0.601112 -5.92985 11.4704 +451 1 16.0428 7.05286 6.2029 -10.6575 13.2953 -5.82849 +452 2 16.855 7.48535 6.46978 4.82485 2.35526 4.73173 +453 2 16.1613 6.12013 6.32007 7.39497 -13.7867 -3.51418 +454 1 15.1327 7.05037 9.11575 3.87713 -5.32828 6.40762 +455 2 15.8626 7.43029 9.61535 2.26476 1.25298 1.00848 +456 2 15.1324 7.53151 8.29313 -1.46271 6.60183 -11.5025 +457 1 6.39444 13.0666 12.8402 5.00849 -18.9174 -4.31708 +458 2 7.14138 12.6166 13.2588 -1.3728 0.0732389 -8.28768 +459 2 6.25233 13.8543 13.3456 -7.70591 16.466 12.3405 +460 1 12.1285 4.48598 13.0882 -38.1563 -9.245 -8.92104 +461 2 12.05 4.67155 14.023 12.2106 4.08095 10.8898 +462 2 11.2367 4.10453 12.8753 29.4794 5.44987 -0.890783 +463 1 11.348 8.18475 7.8598 -17.4059 7.12531 -10.6431 +464 2 12.038 7.63484 7.48501 10.4081 -6.60064 5.31237 +465 2 11.4756 8.28116 8.80352 11.9689 -3.04214 7.26146 +466 1 17.1922 10.8074 7.44155 -25.4203 14.6985 18.6261 +467 2 17.9197 10.2075 7.32737 10.9985 -8.38668 -11.5183 +468 2 17.0629 11.3797 6.67504 9.09121 -1.65978 -2.87918 +469 1 5.25169 18.1248 11.0507 12.0648 3.50666 -3.83562 +470 2 4.62743 17.897 11.7414 -1.9785 0.423337 4.7613 +471 2 4.73712 18.33 10.2687 -7.94827 -3.02158 -5.48025 +472 1 7.57794 17.5568 1.83513 6.93874 5.3114 -35.8297 +473 2 7.86736 16.7596 1.34843 -3.99011 9.3379 11.9664 +474 2 7.57256 18.2518 1.1344 -7.92946 -12.1924 16.8763 +475 1 1.91036 12.9101 13.6013 -3.96045 -14.8375 -19.2024 +476 2 1.39392 12.2568 14.0828 0.939403 1.79227 7.54842 +477 2 2.06766 13.6568 14.1634 3.48639 14.3121 10.7878 +478 1 9.68075 6.78169 14.8149 2.18853 -17.0585 -1.56943 +479 2 9.86519 5.84438 15.0146 -5.66436 10.7434 4.7021 +480 2 10.1054 6.93436 13.9655 -4.91522 4.89205 -3.51643 +481 1 15.2489 4.31705 10.7696 10.3165 19.1063 17.7081 +482 2 16.2033 4.28261 10.8841 1.13215 -16.3849 -6.84609 +483 2 15.045 4.99149 11.4324 -10.9146 -3.35461 -8.40134 +484 1 11.2157 6.13912 0.184288 19.0347 18.6277 4.4365 +485 2 11.389 5.28379 -0.213728 -9.30505 -7.86745 -0.661886 +486 2 10.2971 6.41228 18.7766 -10.0409 -9.92482 -6.17869 +487 1 0.119384 11.3453 15.1007 -14.3711 11.1071 -8.9459 +488 2 18.1083 11.5338 14.3994 8.87914 -3.31428 2.86805 +489 2 18.675 12.1405 15.6491 -0.376992 -6.76779 4.41889 +490 1 7.06293 9.20482 7.26347 16.9728 2.93661 -2.33726 +491 2 6.45996 8.52415 7.5376 -12.746 -11.932 7.1182 +492 2 7.92776 8.76781 7.32981 -4.82181 7.51802 -3.03552 +493 1 18.3776 15.4097 12.3582 -11.3114 -7.16639 4.00893 +494 2 0.682756 15.4096 12.2525 13.0982 4.14044 -6.05458 +495 2 17.9899 15.7976 11.566 2.11158 0.973908 -1.02825 +496 1 16.5513 4.36706 5.24159 -5.09045 5.24791 -23.7034 +497 2 16.6166 4.33687 6.19466 14.1446 -5.59224 10.5876 +498 2 17.404 4.59908 4.81371 -8.86364 -4.80736 14.9956 +499 1 17.7417 3.09647 10.7341 0.291254 -10.6186 -10.4582 +500 2 0.00513181 3.34109 10.9087 8.18655 7.52385 6.55564 +501 2 17.8253 2.23203 10.2933 -8.67083 8.1401 4.47273 +502 1 12.2919 0.0227122 10.1361 2.29147 -28.3523 -7.04943 +503 2 11.4789 0.3695 10.4906 -11.5623 8.87459 2.77288 +504 2 12.9485 0.705533 10.1424 9.22066 20.6222 4.35768 +505 1 10.3653 9.79669 12.372 -8.95345 -3.20907 -9.5203 +506 2 11.0695 9.83133 13.0162 9.21286 -1.60231 7.36796 +507 2 10.2442 8.85709 12.1552 0.446892 6.98856 4.38647 +508 1 0.537603 2.83987 7.02256 -3.09155 -21.8169 -17.6677 +509 2 0.689112 3.48917 7.69969 6.81735 5.32415 12.4887 +510 2 0.745143 1.97019 7.39814 0.967775 11.9311 3.78775 +511 1 0.407687 15.2844 6.91114 -10.1505 12.0239 22.1786 +512 2 0.487576 14.9005 7.81264 0.770838 8.15944 -16.8401 +513 2 0.754028 14.6482 6.29753 4.41733 -17.9374 -4.37366 +514 1 17.0108 7.01877 15.2726 9.75856 -4.98107 -8.16179 +515 2 17.7945 7.53845 15.0774 -4.62906 13.8031 -0.900924 +516 2 17.4019 6.14594 15.3485 -8.43732 -9.20439 7.91006 +517 1 9.04118 12.4266 8.12126 20.8625 -13.8276 -21.4288 +518 2 9.31201 11.8186 7.41014 14.8696 5.22508 9.07579 +519 2 8.11227 12.3461 8.03152 -32.7632 10.2849 9.08461 +520 1 1.26557 1.8876 3.02782 9.65045 8.01813 1.36118 +521 2 0.751817 2.27104 2.32199 -7.08934 -1.28284 -8.05339 +522 2 1.78864 2.63408 3.35807 -1.4257 -10.3882 4.86199 +523 1 4.12138 15.1091 9.73113 11.5132 -2.98862 0.0844269 +524 2 4.08037 15.3711 8.80771 -6.64563 1.38763 -1.25331 +525 2 5.02377 14.7713 9.82789 -5.61093 0.302526 6.22582 +526 1 7.21558 2.18454 14.596 -3.30246 -13.7461 5.2135 +527 2 6.95017 1.78255 13.7582 4.82488 2.3919 4.06302 +528 2 7.77929 2.92256 14.3836 3.82883 9.51482 -6.38734 +529 1 18.5827 14.6796 2.1698 -24.3208 -2.36026 -2.50397 +530 2 0.827663 15.0286 2.10654 6.16868 9.29818 1.18622 +531 2 17.9285 15.4101 2.10387 15.0339 -9.50868 3.05979 +532 1 9.96457 2.76705 12.9307 -6.0306 9.60441 -0.715471 +533 2 9.81933 2.16697 12.1996 2.81266 -10.505 -5.71659 +534 2 9.23975 3.40361 12.8511 1.73763 -0.77134 6.44595 +535 1 2.86173 8.92609 13.0404 7.24036 -2.57601 -2.21085 +536 2 3.32754 9.76259 12.8684 -5.41233 -1.95407 1.34833 +537 2 3.53569 8.30272 13.3558 -0.616664 3.71534 -0.977901 +538 1 3.21505 8.40688 3.66968 15.7234 22.1036 -19.602 +539 2 3.76887 9.07341 3.20135 -16.7118 -11.852 2.14794 +540 2 3.39007 8.60458 4.57891 -0.363765 -1.98929 20.9454 +541 1 5.60252 7.19004 8.53175 5.86958 -4.86959 9.5617 +542 2 5.84506 6.27445 8.70563 -2.01066 -2.63063 -12.6146 +543 2 5.1548 7.42343 9.34691 -7.32508 9.6882 0.185442 +544 1 14.8904 1.34267 1.9851 -2.44355 -11.2972 17.4528 +545 2 14.6303 2.11535 2.51846 2.91157 0.487188 -15.3266 +546 2 15.025 1.53806 1.05778 2.17575 14.4946 -4.76666 +547 1 8.30348 15.1948 0.839181 1.62975 3.11742 -15.2912 +548 2 9.05101 15.1086 1.44328 -1.42893 -5.28711 5.64984 +549 2 7.54504 14.6965 1.17349 5.50357 -4.17517 7.24781 +550 1 15.6062 1.34647 7.22998 12.9139 6.24135 5.03718 +551 2 15.0343 0.764422 6.7383 -10.7397 -5.17 -5.22658 +552 2 15.1371 2.18077 7.35367 -5.42005 -2.19365 2.65732 +553 1 4.96367 13.0608 18.5175 -8.25637 -3.65043 -17.7207 +554 2 5.34878 13.2483 0.722802 8.16177 0.261597 12.4464 +555 2 5.65153 13.2431 17.8644 -2.22894 4.298 3.81358 +556 1 15.3614 8.50445 18.1376 -9.02232 -8.38547 12.9254 +557 2 15.7319 9.00583 17.4156 5.20151 10.9324 -8.24127 +558 2 15.1687 9.14311 0.198883 4.58141 -1.82544 -4.44514 +559 1 12.0904 3.05083 18.3558 5.74067 -18.2993 3.78166 +560 2 12.2947 2.48128 0.458355 -7.48955 9.04159 13.408 +561 2 12.4465 2.47277 17.6781 -3.43414 10.0689 -17.6065 +562 1 13.2065 12.6801 5.18634 5.84251 -1.21193 6.01102 +563 2 13.6832 11.8727 4.98831 0.374712 -2.89081 -11.6293 +564 2 13.5252 12.8732 6.07674 -9.12379 3.52213 -1.02632 +565 1 6.05538 7.10808 0.0622478 7.64822 4.54905 2.96407 +566 2 5.99209 8.01824 19.0386 -2.92171 -4.08442 -8.95141 +567 2 5.21644 6.68693 0.272307 -1.20959 2.69213 5.93171 +568 1 17.7218 15.9656 14.99 27.5308 -15.6865 18.0891 +569 2 16.9388 16.4863 15.1181 -14.3434 5.91292 -14.0866 +570 2 17.911 15.7342 14.0701 -14.8265 10.2647 -3.26624 +571 1 13.1712 0.994875 16.5867 2.52549 -1.56274 -3.32645 +572 2 14.0875 0.750433 16.7652 2.07951 0.899412 2.60052 +573 2 12.7522 0.177983 16.2988 -0.931869 -3.47373 4.92885 +574 1 11.0723 14.6005 7.26575 -13.1255 -10.0571 4.65979 +575 2 10.3507 14.0428 7.62559 10.576 8.81418 -2.61622 +576 2 11.902 14.168 7.50495 -4.44994 -4.81764 -1.49609 +577 1 17.5239 8.59779 2.09084 -4.28833 -20.5194 -15.9758 +578 2 16.6824 8.33187 2.48237 1.37862 7.81735 4.46419 +579 2 17.5834 7.99355 1.32242 5.93631 9.11716 13.4418 +580 1 12.3581 7.93946 1.97566 -1.89696 -6.27914 -3.50436 +581 2 11.9505 8.79823 2.04436 -0.86405 10.6038 1.69948 +582 2 11.9097 7.53044 1.22383 5.98844 -6.29912 5.7943 +583 1 11.9176 14.6241 10.3724 -2.87076 17.8373 18.3305 +584 2 12.1889 13.9308 9.80998 14.0474 -22.5763 -16.4958 +585 2 11.017 14.792 10.1004 -10.4734 4.60408 5.02203 +586 1 6.86179 7.0045 15.5825 0.298402 -7.5032 -11.9192 +587 2 7.72978 7.09161 15.1865 4.58892 -5.83629 -5.839 +588 2 6.8806 7.68521 16.2363 -7.39186 11.3873 16.6815 +589 1 8.0061 4.66768 13.4643 -26.1906 -20.4665 -29.1007 +590 2 7.40104 4.82554 12.6933 13.2028 -5.13213 23.0799 +591 2 8.47723 5.469 13.5831 13.4856 24.6751 2.60837 +592 1 13.392 12.1682 14.29 6.21681 3.24263 -1.56593 +593 2 13.3744 11.2127 14.1772 -7.69192 -2.80185 3.02585 +594 2 13.9051 12.489 13.5384 -1.40129 2.2659 -1.62493 +595 1 14.7806 9.45441 7.28093 -11.5532 20.7697 15.955 +596 2 15.4984 10.0862 7.4818 -3.61589 -14.7511 -6.73617 +597 2 14.0294 9.75726 7.82532 9.94729 -6.45384 -10.5104 +598 1 12.6903 16.9959 3.11063 13.9021 -20.0527 -1.11079 +599 2 13.0479 17.2495 3.95961 -1.86196 6.25123 9.18833 +600 2 12.0243 17.6278 2.88206 -13.6174 14.7021 -2.85583 +601 1 1.14933 7.13689 17.4392 -10.8552 -5.82346 1.42608 +602 2 0.254324 6.85235 17.6903 1.68989 10.0465 1.1249 +603 2 1.04814 7.64429 16.6282 0.816381 -0.80389 -4.56811 +604 1 12.8311 5.11146 15.6849 -17.6595 -4.33947 -1.38663 +605 2 13.5036 4.46543 15.459 7.94947 -3.95791 3.77703 +606 2 13.2565 5.97185 15.6774 7.16 2.75079 -1.64654 +607 1 2.47852 3.39671 5.05511 -15.8601 -20.9034 -7.20071 +608 2 1.89248 3.0773 5.76599 4.829 7.89548 -3.4806 +609 2 3.06433 4.04634 5.42706 4.34046 14.9349 7.02505 +610 1 8.31182 11.2281 13.4853 12.2486 -8.92827 -7.03776 +611 2 8.34382 10.988 14.3869 -16.2376 0.866389 37.005 +612 2 9.12412 10.7865 13.2309 -0.249665 2.67206 -26.3927 +613 1 12.9087 1.417 13.3166 0.0274524 -25.355 19.3096 +614 2 13.4801 1.21198 12.5759 3.32243 8.60198 -10.444 +615 2 12.4274 2.20637 13.1188 -4.80778 18.3372 -7.59901 +616 1 6.3961 13.6531 2.14242 21.3539 -7.72513 -19.5528 +617 2 5.86296 14.1246 2.76583 -10.9825 4.85946 19.6126 +618 2 7.0399 13.1177 2.63436 -6.77103 3.35988 1.82582 +619 1 15.9312 6.57282 12.7577 9.39393 9.94387 -6.4398 +620 2 16.4454 7.11896 12.1297 -10.141 -7.43973 7.84454 +621 2 16.2972 6.7745 13.6327 -0.398164 -4.05689 -3.4507 +622 1 16.8338 0.714138 9.59622 -4.58014 7.56344 -3.36861 +623 2 16.786 18.4184 9.78234 2.45796 -8.84878 0.088887 +624 2 16.3762 0.83732 8.75167 2.21028 0.792186 -0.559114 +625 1 6.14371 11.7069 8.36929 2.81279 3.26044 -4.5559 +626 2 5.21452 11.6136 8.62066 2.93526 -5.28935 1.80511 +627 2 6.46143 10.8412 8.07651 -3.38714 0.356066 2.25694 +628 1 2.85881 8.67012 0.388915 2.79689 11.0982 14.7719 +629 2 2.20875 8.30366 18.4701 -9.93413 -28.5632 -26.9968 +630 2 2.30006 9.32334 0.801848 8.26615 13.7996 15.8107 +631 1 10.1321 10.4555 6.53489 -7.45039 0.329373 10.0784 +632 2 10.6046 9.83719 7.10845 -0.190248 -0.487921 -4.0191 +633 2 10.6634 10.5725 5.74842 5.176 -1.34798 -7.09506 +634 1 6.75471 15.7115 6.57125 -11.9312 -6.35937 -2.57899 +635 2 7.17812 16.0056 7.37746 4.55156 8.98271 2.0062 +636 2 6.84858 16.4009 5.89838 10.4548 -3.40393 4.92981 +637 1 6.44667 13.1112 5.62964 2.65073 6.32881 3.74437 +638 2 6.67596 13.9769 6.00675 -0.0120675 -6.80172 -3.34498 +639 2 5.96115 12.6448 6.31389 0.45756 -2.92263 2.45964 +640 1 16.7937 12.5442 9.80018 5.98989 11.7335 -8.95445 +641 2 16.9887 11.9765 9.05284 -0.702856 -11.4944 -2.64553 +642 2 17.0098 13.4184 9.45025 -4.64512 -2.35242 9.41775 +643 1 6.08081 2.94855 2.81201 5.81343 6.87552 13.2918 +644 2 6.21399 3.88965 2.59312 -1.02666 -12.0092 -4.68113 +645 2 5.77459 2.45978 2.03916 -1.91968 5.61369 -5.09877 +646 1 10.8797 3.26448 3.27711 -5.41025 -2.45564 -6.20574 +647 2 10.301 3.99846 3.49319 -0.0844139 2.78359 4.78679 +648 2 10.5123 2.93026 2.45079 3.61554 -5.12824 0.569032 +ITEM: TIMESTEP +40 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.73557 7.01799 17.9607 21.964 -6.69295 -3.41675 +2 2 7.837 6.97936 18.244 -22.923 1.28376 8.03757 +3 2 8.84363 6.25859 17.3828 1.27689 0.0651665 -4.69765 +4 1 18.6647 8.30209 6.83035 -0.644058 3.99523 -48.5507 +5 2 0.211245 8.12789 5.86514 -9.60619 8.91963 25.083 +6 2 0.465598 7.58914 7.26037 9.90688 -14.2806 22.1152 +7 1 8.44495 18.6364 6.8238 -19.0399 -0.344231 6.51496 +8 2 9.34052 0.200584 6.61788 21.6732 5.78047 -4.99449 +9 2 7.92466 0.711623 6.44684 1.16681 0.183702 -1.11302 +10 1 6.56005 1.80411 11.6838 -38.7214 4.43655 14.793 +11 2 5.75321 2.272 12.0538 30.5925 -16.6996 -9.96133 +12 2 6.22943 0.898268 11.5156 6.32845 11.0599 0.0206858 +13 1 7.08366 5.68816 2.38617 22.7225 -30.9477 -12.475 +14 2 6.58152 6.21056 2.95839 -27.8787 23.1579 37.4024 +15 2 6.84697 6.04683 1.54845 0.038941 9.08719 -25.9535 +16 1 16.22 10.2137 16.0864 41.4588 -5.13522 6.23048 +17 2 17.1921 10.3703 16.208 -28.8473 -8.8876 -9.54756 +18 2 15.8271 11.0171 16.4051 -13.971 12.6367 2.51598 +19 1 10.6448 14.9575 2.33364 6.27542 19.2207 -0.856148 +20 2 10.5562 14.6084 3.22703 2.40752 -4.54155 -3.02292 +21 2 11.1101 15.8129 2.46012 -8.85901 -18.4002 -3.84051 +22 1 17.1611 8.2532 10.553 -11.2529 -0.0170881 12.6501 +23 2 16.8393 8.94572 11.1538 -1.12797 -5.57792 -5.31501 +24 2 17.9446 8.61302 10.1436 10.8511 4.56282 -2.94704 +25 1 14.7728 15.897 16.3892 -19.7826 14.9663 0.46496 +26 2 13.8411 16.2137 16.4626 21.4068 -5.53606 -7.5515 +27 2 14.9622 15.5552 17.2653 -0.403084 -10.0705 4.87845 +28 1 12.136 13.4022 0.475357 -11.3959 -2.02194 -12.751 +29 2 11.9408 13.3873 18.1673 8.9331 -2.53085 4.8524 +30 2 11.4037 13.9022 0.849725 6.62825 2.84238 11.8203 +31 1 9.29338 5.44787 4.01163 24.6694 12.616 -29.9837 +32 2 8.80858 5.1972 4.76287 -21.098 -14.9153 34.0625 +33 2 8.63435 5.49966 3.31701 -4.42724 -1.21089 -8.36553 +34 1 1.79376 4.18976 11.6282 4.46954 -46.7602 7.51249 +35 2 1.70048 5.09501 11.8512 -4.37305 32.1952 10.6933 +36 2 2.09275 3.70286 12.4334 -4.9207 12.4729 -20.4441 +37 1 2.01732 6.80615 8.34226 1.64844 10.8358 -0.647304 +38 2 2.37448 7.3471 9.0762 -2.77819 -13.6149 -8.9692 +39 2 1.92609 5.89421 8.65385 1.80745 6.26657 1.98394 +40 1 5.38901 4.42498 7.95307 14.0474 9.0477 19.097 +41 2 5.49608 3.48465 7.79451 -4.39314 -7.26091 -3.25333 +42 2 4.79389 4.80722 7.31869 -10.598 0.276841 -18.5158 +43 1 3.29732 2.94293 17.5086 17.2208 -30.0882 -17.6092 +44 2 4.02601 3.30007 16.978 -4.8938 2.423 1.99348 +45 2 2.81217 3.66256 17.8655 -12.7512 26.7583 13.4218 +46 1 7.44366 5.31542 6.10005 -2.04578 -15.3999 -38.6663 +47 2 8.07874 5.97061 6.33436 13.5587 20.8049 21.0336 +48 2 6.95124 5.08125 6.86821 -11.582 -6.53412 22.3247 +49 1 9.78574 7.01841 12.0035 -14.224 -5.31732 -23.9819 +50 2 10.3573 6.41663 11.5027 -2.93892 5.75769 9.08141 +51 2 9.02058 7.16943 11.392 19.9248 1.87014 17.2782 +52 1 14.0222 3.60384 8.07347 21.1656 -3.6634 36.3987 +53 2 13.9951 4.24089 7.37961 -2.65045 17.7741 -13.562 +54 2 14.5465 4.02482 8.8088 -19.0215 -13.1146 -21.9867 +55 1 4.60432 17.1743 3.97092 -4.17058 -8.50894 9.4345 +56 2 5.51528 17.3741 4.10719 24.7317 1.00316 8.45766 +57 2 4.31895 17.8257 3.35422 -16.1123 9.67587 -20.1592 +58 1 16.4938 16.6102 10.1803 -22.58 10.2442 28.8776 +59 2 15.6971 16.8258 10.7464 27.0105 -10.9286 -19.8859 +60 2 16.1827 15.9878 9.51957 -5.57273 -0.00226425 -4.98818 +61 1 1.9645 4.84741 0.368078 -14.0488 -12.8308 -13.2388 +62 2 2.69854 5.15593 0.879033 14.2396 9.43314 15.7095 +63 2 1.5724 5.64147 0.000503254 -0.0595591 4.00938 -5.12573 +64 1 11.6747 13.3071 16.3147 -7.05005 22.2307 18.0491 +65 2 11.0866 12.5598 16.3919 -3.1788 -17.5748 -3.92498 +66 2 12.2584 13.1709 15.5748 2.75178 -8.36686 -13.1919 +67 1 10.131 11.038 16.8986 -21.0542 26.9507 -1.58256 +68 2 10.4848 10.1706 16.8573 15.2828 -28.4038 0.505132 +69 2 9.17797 10.924 16.7712 4.48065 0.743861 -0.190366 +70 1 11.7352 17.4666 13.4614 -1.07936 25.6776 8.56908 +71 2 12.4835 17.2209 12.9203 3.02318 -9.35187 -8.63799 +72 2 11.8077 18.4454 13.5145 -0.798306 -16.7366 -1.43427 +73 1 6.39395 9.3313 12.2301 16.0138 21.1557 17.835 +74 2 6.78657 8.92292 11.474 4.59605 -10.3711 -18.9433 +75 2 7.12055 9.89522 12.5742 -21.4515 -7.31443 1.84288 +76 1 16.2436 12.8045 2.69297 9.19112 6.28957 -1.09055 +77 2 17.1119 13.1995 2.45018 -21.0084 -1.00278 4.98407 +78 2 15.5746 13.5129 2.79044 13.212 -4.74068 -2.98151 +79 1 0.66547 12.6008 5.89246 44.3801 0.278469 12.8923 +80 2 0.944588 12.4662 4.9918 4.15776 -1.70344 -11.3497 +81 2 18.3844 12.6561 5.85431 -44.3715 7.63264 -5.03051 +82 1 5.23201 16.4301 18.4413 -23.1671 11.3407 -2.74477 +83 2 5.81563 15.7669 18.0873 14.8521 -9.88299 1.40517 +84 2 5.51268 16.7513 0.656182 8.57816 -5.72834 2.04059 +85 1 0.568352 7.66823 4.13077 -28.9792 -20.0076 22.3714 +86 2 18.6051 8.03762 3.49503 -7.9612 4.34402 -11.87 +87 2 1.4037 8.01472 3.91532 39.463 15.435 -13.2826 +88 1 3.11888 8.95318 6.49662 60.4725 2.42495 -6.82714 +89 2 3.7308 8.46704 7.08062 -7.96075 9.2896 -8.18079 +90 2 2.27986 8.68504 6.76207 -50.4171 -10.8396 15.4956 +91 1 7.30368 10.3509 16.2473 20.2996 0.0228567 -17.1566 +92 2 6.66358 10.504 15.5564 -7.99994 0.888183 -0.524161 +93 2 6.82737 10.217 17.0566 -12.2765 1.21271 14.6854 +94 1 11.12 1.01485 5.00375 -0.0102216 2.84952 14.1843 +95 2 11.0857 1.87302 4.56078 2.3673 -3.0702 -4.20032 +96 2 10.7324 0.367128 4.41621 -3.73217 -2.39612 -13.1961 +97 1 4.37027 2.7904 13.2033 3.18584 17.5115 -8.99997 +98 2 4.79356 3.08499 14.0007 6.25053 15.0735 9.59097 +99 2 4.18046 1.89747 13.4272 -8.57413 -32.1756 -2.785 +100 1 8.40183 10.1302 1.81819 -11.3119 21.1596 -20.1509 +101 2 8.22596 10.8234 2.46526 3.55036 0.443395 1.34914 +102 2 8.74004 9.40086 2.30376 11.7587 -22.7948 15.5041 +103 1 10.4641 1.71908 15.5611 14.2583 -4.22402 3.33599 +104 2 11.4066 1.52258 15.371 -17.8532 5.60176 1.9802 +105 2 10.08 2.13518 14.7824 5.57904 -1.0897 -7.54918 +106 1 2.70316 12.9014 7.80195 3.19617 10.9991 1.8073 +107 2 3.3212 13.5754 7.49282 0.460726 -0.40643 1.73206 +108 2 2.13336 12.7538 7.04495 -5.07282 -6.75217 -1.11681 +109 1 3.70861 11.6625 5.14703 20.6482 18.5599 0.117703 +110 2 3.55555 10.8287 5.56068 -6.18613 -18.2271 10.4705 +111 2 3.04771 11.7826 4.47739 -15.5561 1.61657 -8.41129 +112 1 6.75631 14.4548 16.9127 8.94674 -1.78931 -0.924301 +113 2 7.71443 14.3361 16.9267 -6.94418 4.38523 0.882829 +114 2 6.52635 14.6721 16.0018 -2.96874 0.297136 0.835917 +115 1 14.1768 14.5549 3.37546 -9.20747 -5.25648 5.53536 +116 2 13.5738 15.2994 3.18581 6.88801 -12.7747 3.05988 +117 2 13.7349 13.9262 3.9882 4.46288 16.3838 -11.0193 +118 1 8.36945 18.1316 16.043 -50.6417 14.5597 -0.377943 +119 2 8.83326 17.39 16.374 32.1095 -21.5179 4.54953 +120 2 8.87194 0.178112 15.6264 24.4627 6.71878 1.23367 +121 1 4.74402 1.66109 4.92978 -19.7446 -31.5867 36.4561 +122 2 3.83516 1.95374 4.92736 -8.28526 7.01041 1.88485 +123 2 5.14187 2.10852 4.23181 25.7722 28.9669 -41.4039 +124 1 15.0327 12.6922 16.4463 -14.1895 -13.4373 -36.9651 +125 2 14.5853 13.1594 17.1179 -4.44761 17.5587 33.5367 +126 2 14.3173 12.6168 15.7704 28.0544 -5.79477 6.54775 +127 1 15.7455 18.4472 16.8494 -36.7721 -17.2537 -45.0168 +128 2 16.3082 18.5742 17.5575 42.6678 12.9246 46.9817 +129 2 15.6033 17.4929 16.845 -6.46687 1.33922 -4.84851 +130 1 1.19925 1.17644 16.5482 3.81725 -14.252 -17.647 +131 2 1.9494 1.76296 16.5282 11.9166 8.08174 5.38627 +132 2 0.720072 1.41993 17.3243 -10.8728 8.87917 17.8692 +133 1 18.1194 4.51517 15.8978 -9.12682 11.3324 16.5545 +134 2 18.3907 3.99589 15.1624 6.35448 -14.0345 -18.3092 +135 2 0.212938 4.54105 16.5062 3.72114 1.23331 1.72655 +136 1 12.2575 16.9791 16.1441 20.307 19.4582 -44.4732 +137 2 11.5756 16.5974 16.6415 -35.2707 -20.5418 23.5889 +138 2 11.9443 16.955 15.2053 9.79722 2.45701 21.3583 +139 1 15.9948 2.53341 18.0767 10.9381 -15.7258 5.9061 +140 2 15.4972 3.23449 18.4655 -6.78731 22.0319 12.1926 +141 2 15.8185 2.63494 17.1497 -1.81081 -2.22204 -19.1287 +142 1 6.71322 13.8205 10.2184 4.21251 -0.72826 -19.8354 +143 2 6.51318 13.5527 11.1172 -1.15071 -8.01371 4.0626 +144 2 6.63912 13.0526 9.6212 -3.83744 4.98216 12.3358 +145 1 10.1462 18.2988 2.74675 -22.097 -20.0437 20.6404 +146 2 10.3757 0.350258 2.15404 6.85623 19.4082 -18.4799 +147 2 9.18692 18.1396 2.61143 20.6475 -0.265938 -2.33946 +148 1 3.01179 17.7216 6.11391 16.3646 11.1083 -7.5066 +149 2 2.20644 17.7129 5.60578 -13.7656 -5.82691 -3.27397 +150 2 3.67703 17.9821 5.44947 -4.29715 -10.1951 11.4126 +151 1 12.5763 16.9057 8.00279 34.6812 6.34788 -19.799 +152 2 11.842 16.3339 7.82778 -18.535 -10.6459 7.52248 +153 2 12.4277 17.4882 8.74445 -13.6741 4.98834 7.73701 +154 1 14.8867 15.2801 8.21669 15.2681 -20.6133 -0.236719 +155 2 14.2473 15.9935 8.15265 -4.83203 2.49296 -8.82369 +156 2 15.4177 15.201 7.39136 -14.8487 16.0275 12.7595 +157 1 17.673 18.2386 0.358056 6.39969 9.72416 1.64776 +158 2 18.5627 17.8182 0.243387 -17.6184 17.4743 1.20562 +159 2 17.7074 0.56338 0.562155 11.394 -25.7036 -4.78753 +160 1 0.840605 10.4115 1.35744 37.4959 50.4012 -24.017 +161 2 0.0672579 9.99096 1.64345 -42.7842 -22.4511 10.6341 +162 2 0.58692 11.2092 0.808654 3.76922 -28.1369 19.051 +163 1 1.6843 12.2358 3.38047 -6.18426 -19.2714 -7.57792 +164 2 1.35621 11.4726 2.83119 9.65923 28.3457 4.48748 +165 2 1.68469 13.0653 2.87986 -2.69674 -10.3555 -4.68476 +166 1 0.583101 17.235 4.89274 4.80321 -10.1773 15.6529 +167 2 18.7212 18.0548 4.74777 -0.344371 -10.7938 17.6071 +168 2 0.457865 16.8228 5.79389 -3.26711 20.5272 -26.9728 +169 1 1.10197 0.931397 9.43269 -15.4399 -19.3078 -9.02275 +170 2 1.25908 0.443364 10.2575 0.781623 10.2528 -2.87546 +171 2 0.281175 0.525265 9.08113 16.3171 12.9297 7.39947 +172 1 16.7532 2.33623 13.2905 -6.48112 -9.83965 38.5991 +173 2 16.8955 2.59135 12.4052 6.16672 6.51778 -37.0535 +174 2 16.4416 1.41783 13.3009 4.47832 4.66932 -0.969858 +175 1 2.60624 15.8504 12.1681 -27.4943 19.2901 -21.9402 +176 2 3.16839 15.391 12.7532 19.3125 -15.6847 20.968 +177 2 2.92961 15.6774 11.278 4.5792 -4.36857 -3.32021 +178 1 16.4212 15.6424 6.03078 2.33398 -27.7044 12.4884 +179 2 17.3276 15.7008 6.32 9.77501 -6.8374 8.24343 +180 2 16.3266 16.4053 5.49767 -10.7497 25.3256 -21.0495 +181 1 5.80196 5.07502 11.792 -7.0375 5.38003 9.08436 +182 2 5.27256 5.62589 12.4097 12.9595 -6.51078 -10.685 +183 2 5.4277 4.18781 11.8485 -2.70068 5.27459 0.5345 +184 1 15.1729 4.86274 0.750774 -1.10571 10.9128 -33.6343 +185 2 15.2042 4.59535 1.64712 -4.27265 -9.78555 34.3171 +186 2 14.3466 5.34824 0.643665 4.19718 -3.49047 -1.12139 +187 1 16.3347 16.3636 2.07743 2.17372 -8.94604 27.567 +188 2 16.248 16.684 3.01162 -4.2135 -4.93901 -27.3972 +189 2 16.5997 17.1143 1.55727 4.53602 12.7734 -5.95158 +190 1 0.261441 4.84804 3.8055 -0.147017 -56.3045 13.8461 +191 2 0.475233 5.74211 3.84367 9.07909 56.4423 -0.745388 +192 2 0.927869 4.41838 4.37361 -9.48651 2.83213 -9.85838 +193 1 2.95802 15.0603 15.1014 -0.943114 0.172839 -27.3629 +194 2 2.80338 14.7297 15.9709 -3.98201 -9.31011 23.138 +195 2 2.36314 15.8122 15.0164 6.10514 4.60789 3.27938 +196 1 1.13815 14.652 9.54287 -29.9359 -26.3887 42.7894 +197 2 1.85794 14.2975 9.07203 33.137 -5.88851 -26.0645 +198 2 1.02375 13.9289 10.2175 -6.6715 26.0405 -18.8729 +199 1 13.5762 16.6063 11.5459 8.2131 -23.6119 0.793767 +200 2 13.33 17.296 10.9485 -9.11427 22.0857 -7.2987 +201 2 13.1805 15.8285 11.1175 -0.169415 1.89227 9.19008 +202 1 4.67714 1.46335 0.758621 16.4224 4.90719 -8.19047 +203 2 4.16601 2.0159 0.158762 -4.20381 1.9839 -0.0593356 +204 2 4.09672 0.7797 1.07984 -10.7002 -7.55851 6.47825 +205 1 1.4518 18.552 11.8572 6.2605 -28.7314 5.6203 +206 2 1.30143 0.363179 12.6934 -0.382356 1.32639 0.00372943 +207 2 1.68394 17.6168 12.0771 -1.80479 24.861 -1.36748 +208 1 11.5075 10.1198 4.02095 -18.4811 -8.70186 23.5865 +209 2 11.1917 10.5684 3.24759 -2.79925 6.67004 -19.1711 +210 2 12.4478 10.2129 4.02159 23.6747 0.339266 0.782627 +211 1 8.31226 12.1774 3.6909 13.3967 -8.0925 -50.6166 +212 2 9.08853 12.6634 3.95409 8.19758 6.83683 10.985 +213 2 7.73108 12.1161 4.40989 -25.5486 3.81511 42.2514 +214 1 14.4234 4.01167 3.27932 -6.39999 -0.808874 -15.5703 +215 2 15.0318 4.04602 4.01015 9.81333 2.6424 13.2185 +216 2 13.6949 4.61166 3.47516 -0.628596 -1.04819 4.76047 +217 1 5.60276 1.68001 7.51543 46.6974 51.3536 -38.165 +218 2 4.99884 1.09753 7.87161 -47.5789 -43.021 28.4342 +219 2 5.32972 1.80197 6.58421 6.01087 -7.11276 10.7862 +220 1 17.8847 1.08156 4.86879 -16.2479 -18.084 1.95698 +221 2 18.6198 1.37964 4.35055 14.6356 14.0949 -7.48199 +222 2 17.763 1.66674 5.61639 2.20316 6.60999 2.39214 +223 1 6.81142 9.41573 4.49306 -0.655622 0.432156 7.98772 +224 2 6.876 9.60924 5.45033 2.30801 -5.82211 -14.8304 +225 2 7.69814 9.2085 4.16641 0.21776 -0.211816 8.23149 +226 1 2.64622 14.9044 1.97705 -19.6169 -6.34757 32.4999 +227 2 3.24366 14.6749 2.7111 -2.05224 3.38495 -12.0409 +228 2 3.14951 14.9574 1.1885 18.3224 0.185563 -21.7099 +229 1 17.3026 12.9105 13.1506 5.97988 10.8617 -4.35729 +230 2 16.4943 13.3715 13.3508 -17.5214 -4.76439 4.13034 +231 2 17.8495 13.6655 12.9025 6.83053 -7.65676 -2.15198 +232 1 14.953 10.5544 1.38215 35.2581 29.1908 17.9973 +233 2 15.5812 11.2612 1.74238 -25.4064 -29.0048 -15.0024 +234 2 14.0938 10.9575 1.42777 -9.92862 1.12257 -1.65093 +235 1 5.7132 6.77849 4.57909 1.57168 19.8101 -12.7812 +236 2 6.1646 7.64962 4.62346 -11.1008 -12.4177 -0.29751 +237 2 6.30742 6.13992 4.97063 6.93571 -3.41618 11.3539 +238 1 8.02607 8.31482 10.3199 -6.67367 -6.11991 -5.1902 +239 2 8.5826 9.1064 10.2496 0.567217 -7.04018 -13.4516 +240 2 7.81744 7.96553 9.42928 8.80325 8.4252 13.4279 +241 1 13.463 18.3942 5.75922 18.2094 9.72717 -25.7917 +242 2 12.7029 0.253225 5.44631 -3.25776 3.56949 4.30859 +243 2 13.1448 17.7819 6.40042 -11.4028 -12.4364 22.7676 +244 1 0.157572 2.62906 0.18715 -8.27583 -44.4001 -2.30616 +245 2 17.9404 2.90438 -0.139246 -4.84787 10.7772 1.25282 +246 2 0.728557 3.33866 0.428035 8.4047 29.5908 2.16632 +247 1 12.7834 11.0467 9.74512 50.2143 -37.9981 33.2215 +248 2 11.9361 11.0491 9.39224 -54.8114 3.18277 -19.015 +249 2 12.8684 10.1188 10.1004 3.84712 25.3375 -10.5627 +250 1 0.745434 12.1889 11.0782 -25.5268 2.00553 -1.18025 +251 2 18.4134 12.2219 11.1204 10.6569 -0.780029 -7.62666 +252 2 1.00048 12.4147 11.9671 12.4315 1.99225 10.3147 +253 1 5.08453 7.29937 13.4403 2.24753 -3.99956 1.86213 +254 2 5.64891 7.85147 12.8757 -3.98378 2.58677 10.115 +255 2 5.52437 7.26557 14.3066 0.821915 -2.02828 -9.69703 +256 1 1.22699 6.88005 11.8698 42.6355 29.3241 27.8417 +257 2 0.513102 7.24659 11.3736 -15.3023 8.70694 -9.89945 +258 2 1.76616 7.68013 12.1994 -27.3906 -36.7234 -16.475 +259 1 15.5048 9.56381 12.3059 14.0365 -21.5239 -8.17825 +260 2 15.0446 10.3738 12.2505 -11.2614 35.3449 -7.27588 +261 2 15.2981 9.243 13.1696 0.51668 -8.53923 17.0206 +262 1 16.6213 12.8097 5.50479 11.7533 -20.9364 35.7876 +263 2 16.4281 13.7341 5.58129 -4.58024 20.9264 -6.48074 +264 2 16.496 12.5383 4.61195 -7.15835 1.38375 -28.6034 +265 1 6.25272 9.92074 0.051253 25.5558 -5.2213 19.2814 +266 2 5.65499 10.4134 0.617489 -6.63873 2.74854 -0.55683 +267 2 7.09279 9.88715 0.575545 -19.794 1.5448 -11.6918 +268 1 12.3217 6.11544 4.06855 24.0308 27.0278 -26.8963 +269 2 12.2667 6.69224 3.25542 -0.750296 -12.6773 27.7542 +270 2 11.603 5.51542 4.01585 -23.4349 -14.6267 -3.11795 +271 1 0.228308 12.8043 0.188232 11.1572 0.898125 2.61316 +272 2 0.191448 13.5221 0.829575 -7.01271 0.62324 2.49922 +273 2 18.423 13.1312 18.0517 -4.48315 2.42872 -7.20237 +274 1 3.7281 18.597 8.57641 -7.3642 13.4464 17.6561 +275 2 3.55952 18.0214 7.8301 -5.82536 1.28732 -6.71467 +276 2 2.87154 0.379366 8.79158 11.2944 -8.20129 -4.53508 +277 1 7.45075 17.3023 4.47746 -12.4687 -31.8552 -5.62811 +278 2 7.62794 18.1881 4.68695 9.53175 40.2972 16.7849 +279 2 7.50734 17.3052 3.52795 -1.99738 -6.99443 -12.8094 +280 1 9.24058 17.0897 12.2501 -24.9009 9.53262 -6.54721 +281 2 9.25026 16.4035 11.594 -4.50925 -12.7792 -11.7902 +282 2 10.1098 17.0766 12.5981 28.7243 3.47903 16.8433 +283 1 13.2876 12.9366 7.99409 13.1339 47.0026 -12.7195 +284 2 13.3658 12.2269 8.61754 6.78146 -9.97429 11.7811 +285 2 13.946 13.6564 8.215 -16.5737 -23.9385 -2.8436 +286 1 14.9278 2.97205 15.3542 -22.0243 3.95222 27.314 +287 2 14.2978 2.24466 15.255 3.92553 0.418625 -2.59085 +288 2 15.495 2.9795 14.6023 14.212 -3.72656 -21.152 +289 1 9.88733 15.5502 16.9939 -6.96656 2.06857 9.21519 +290 2 10.3024 14.7219 16.7214 3.24805 0.519307 1.1538 +291 2 9.47388 15.4159 17.8681 4.17307 -0.448199 -10.2742 +292 1 11.3272 8.33778 16.5655 -12.1447 -4.13113 3.07889 +293 2 10.5941 7.97459 16.029 11.4521 -0.447246 11.036 +294 2 11.3675 7.80686 17.3849 -1.98947 6.30133 -12.9317 +295 1 3.91087 18.2078 16.7523 8.10648 -24.8729 2.7978 +296 2 4.29329 17.4751 17.2712 -2.30537 5.45923 -13.1249 +297 2 3.83261 0.235403 17.405 -4.96911 23.3333 9.68201 +298 1 2.20524 4.16671 8.93127 -30.922 4.24465 -33.9389 +299 2 3.10409 4.18899 8.66341 29.7515 -2.18627 -0.590115 +300 2 2.16419 4.10976 9.8632 4.73941 -5.36165 36.7803 +301 1 9.8752 10.3748 9.71669 16.1383 -34.8575 15.3318 +302 2 9.43878 11.1114 9.34267 -12.9257 32.2344 -10.6144 +303 2 10.0704 10.5459 10.6459 0.567735 2.49547 1.17829 +304 1 9.70603 0.859612 10.8594 11.2219 3.05072 8.41213 +305 2 9.26848 0.0594607 11.2011 -2.07101 7.3453 -10.3505 +306 2 9.18365 1.30902 10.1791 -6.8322 -10.1071 2.86508 +307 1 9.20299 15.1273 10.2305 31.122 11.5717 5.63223 +308 2 8.76871 15.6899 9.60445 -9.85228 15.7354 -8.32779 +309 2 8.63472 14.3875 10.3233 -23.0991 -20.0884 3.25194 +310 1 0.96837 9.47951 10.2963 -70.5876 8.50765 14.6853 +311 2 0.835229 10.4182 10.5095 11.9906 -6.34251 -2.52384 +312 2 1.84768 9.33537 10.0919 56.817 -0.102153 -14.2985 +313 1 16.9556 4.85371 8.1764 15.2186 15.5475 -39.5257 +314 2 16.4324 5.61135 8.41217 -10.5813 9.18021 7.17639 +315 2 16.8473 4.22258 8.84986 -2.43363 -23.5078 29.961 +316 1 14.6968 14.7113 0.249291 21.1749 6.84176 -19.9636 +317 2 15.2416 15.0749 0.948116 1.7369 4.80193 6.96981 +318 2 13.9408 14.343 0.670519 -22.6431 -9.26918 11.3127 +319 1 3.62773 11.0513 9.55661 13.6415 -11.4582 11.5887 +320 2 3.64622 11.3868 10.4653 -1.2087 2.23818 -2.33891 +321 2 3.18854 11.7052 9.01978 -9.00441 8.94912 -6.83793 +322 1 11.1486 10.7845 1.39435 -11.9859 -27.9615 14.113 +323 2 11.4982 11.6036 1.1014 8.88176 28.2378 -14.4203 +324 2 10.2242 10.7355 1.11217 4.88573 2.00485 1.40976 +325 1 13.1617 7.12114 12.7848 27.9985 9.25187 0.204961 +326 2 14.1485 7.05909 12.8492 -22.0105 -1.86773 -1.16605 +327 2 12.8387 6.22307 12.8528 -4.13181 -6.51108 -0.646654 +328 1 9.62686 1.89618 0.979059 -11.1933 -2.25437 -17.4068 +329 2 8.86583 1.44793 0.536192 15.085 16.0595 8.12302 +330 2 10.1008 2.43338 0.313674 -4.24921 -13.4265 6.88026 +331 1 10.6169 13.5248 4.60784 -18.2432 -3.19473 -12.9411 +332 2 11.3551 12.9251 4.5569 15.1862 -3.85234 3.34493 +333 2 10.6581 13.9134 5.47279 3.49634 8.81883 14.723 +334 1 14.3649 1.74425 10.9305 5.54735 -12.1033 0.31392 +335 2 15.2006 1.47853 10.5325 -1.1471 -9.04293 -1.43649 +336 2 14.4646 2.6903 10.9924 -3.65076 12.6994 -0.169483 +337 1 14.6084 12.2765 11.688 7.48969 -0.0414248 52.7612 +338 2 15.3889 12.4412 11.1797 12.3837 0.874018 -20.9659 +339 2 13.8613 12.0797 11.1652 -22.2598 -6.69151 -32.5036 +340 1 8.22131 5.06515 9.81151 31.4859 -23.4564 -24.7693 +341 2 7.50576 5.35441 10.3398 -29.672 2.17434 15.6894 +342 2 8.09879 4.11038 9.58602 -2.47918 22.6636 6.16193 +343 1 1.53723 16.856 18.3772 -4.91865 -38.0309 19.5229 +344 2 1.81973 17.2424 17.568 8.52952 11.4507 -22.0862 +345 2 1.68062 15.8825 18.2332 -2.55663 27.9439 5.8223 +346 1 1.48989 17.248 15.3251 -39.2991 7.69546 7.77355 +347 2 1.63979 18.1273 15.7491 -10.9611 -20.0854 -9.27397 +348 2 0.505086 16.9983 15.3475 43.8724 16.6347 0.193712 +349 1 3.67894 5.68848 6.10927 6.21387 -9.44646 -9.55971 +350 2 3.15123 6.21186 6.69497 -13.0277 9.84767 14.8728 +351 2 4.18038 6.32117 5.58457 4.58642 -2.3545 -2.10993 +352 1 12.397 9.46521 14.1943 -11.4291 42.6821 2.6577 +353 2 12.6884 8.68898 13.7764 17.0449 -39.3969 -17.6043 +354 2 12.207 9.20402 15.087 -1.24705 -6.16332 16.3323 +355 1 4.0418 15.2774 6.91931 -38.8927 -2.71008 6.44315 +356 2 3.58633 16.0735 6.61178 -2.62598 -4.70343 -0.502904 +357 2 4.94439 15.4914 6.84844 41.7142 6.1892 -4.79175 +358 1 0.605801 8.58372 14.9539 0.254512 0.326548 7.88367 +359 2 0.527439 9.52499 15.1145 -2.4036 7.40824 2.35469 +360 2 1.30759 8.52231 14.3126 8.3049 -1.83762 -9.50966 +361 1 12.9717 8.29262 10.2927 -22.7594 16.3387 10.1639 +362 2 13.6731 7.84025 9.84078 14.5836 -10.6745 -2.92467 +363 2 13.0109 8.02582 11.2281 0.923047 -2.44701 -11.6389 +364 1 15.3232 7.71175 3.53457 4.84131 -0.438878 0.085747 +365 2 14.6048 7.2242 3.18847 -27.3478 1.70601 -26.568 +366 2 15.5504 7.10949 4.22607 20.3905 5.82918 25.2924 +367 1 17.3123 6.68101 0.0543458 25.2448 -11.5383 1.06581 +368 2 16.8643 5.84811 0.208139 -4.52976 -2.78536 3.6701 +369 2 16.6324 7.27442 18.4294 -24.004 18.1506 -8.07094 +370 1 8.88314 6.92259 7.79709 31.0126 27.4325 -12.7619 +371 2 9.82162 7.25311 7.83141 -27.6614 -7.83044 -3.12143 +372 2 8.85418 6.18364 8.38751 -5.1761 -15.9168 16.933 +373 1 12.3742 0.616612 1.23426 0.620177 6.71182 8.7173 +374 2 13.3152 0.448787 1.38768 -5.31542 -0.309906 -0.296651 +375 2 12.0908 0.227811 0.410291 5.35555 -3.35826 -6.33914 +376 1 5.63073 15.1419 14.5354 -14.6404 -24.282 5.65856 +377 2 4.69276 15.2374 14.754 2.80482 -4.42056 0.607876 +378 2 5.89918 16.0006 14.2671 15.2941 25.5531 -11.1631 +379 1 3.85325 6.46699 1.73385 7.01958 -17.0097 2.38606 +380 2 3.51461 7.31896 1.46783 -8.17546 12.9796 -1.79528 +381 2 4.05434 6.54403 2.67764 -3.63249 4.46552 -6.11981 +382 1 3.88854 11.6061 12.3354 -12.5844 1.40703 6.82309 +383 2 4.76337 11.9285 12.5525 8.64878 0.03141 -1.44708 +384 2 3.2838 12.173 12.8501 6.64476 -9.03704 -9.92286 +385 1 5.37483 3.86954 15.8708 7.06931 -74.8011 -5.77053 +386 2 6.14587 3.26348 15.6611 -29.2279 19.2574 6.80998 +387 2 5.70286 4.72315 15.8147 21.5682 55.4234 -2.96121 +388 1 14.3763 10.2794 4.46201 -32.4101 28.4329 49.0365 +389 2 14.443 9.83621 5.32683 0.971611 4.81404 -7.53945 +390 2 14.839 9.74155 3.87936 25.2894 -34.3452 -37.3821 +391 1 7.80918 17.3929 9.15872 22.1479 -28.1908 5.37522 +392 2 6.96403 17.5587 9.551 -17.6194 9.20761 3.63927 +393 2 7.9906 17.9725 8.42371 -6.45863 11.4679 -7.92664 +394 1 4.50911 14.4925 3.93603 -3.72296 -18.8397 -53.7951 +395 2 4.39275 15.3834 4.18687 0.185157 34.2159 14.5975 +396 2 4.6886 13.9787 4.68865 6.61933 -20.0316 37.8242 +397 1 14.2759 7.39669 15.8018 -25.3443 -8.35453 -18.4147 +398 2 15.2098 7.32722 15.7472 31.3188 -3.09541 -3.64929 +399 2 14.1076 7.77613 16.6483 -2.08075 9.82337 20.7866 +400 1 2.98131 18.2876 1.92072 -8.89863 -34.7534 -28.0783 +401 2 2.43865 17.6277 1.38436 23.5626 24.7731 19.3405 +402 2 2.37413 0.302092 2.22775 -14.7638 14.2119 8.82016 +403 1 7.98427 1.62335 4.57287 -40.8947 -0.445207 11.16 +404 2 7.39585 2.15768 4.00383 13.1095 -6.60943 2.01257 +405 2 8.85324 1.63658 4.22836 26.1363 6.2526 -15.7033 +406 1 2.50726 14.1431 17.6951 16.6159 21.4268 -10.1577 +407 2 1.94925 13.5738 18.1946 -18.2656 -19.6261 9.9334 +408 2 3.40865 13.8863 17.9244 2.82527 -4.33175 1.96247 +409 1 0.811695 1.74837 13.8925 -21.7292 3.59652 4.70406 +410 2 0.795118 1.42008 14.8166 -3.87613 7.88135 -16.9479 +411 2 18.5211 1.96459 13.6307 25.6616 -9.0685 11.0917 +412 1 4.4852 18.6484 13.9168 -33.7534 10.3053 3.09674 +413 2 5.3921 18.406 13.9761 25.2496 -8.78408 2.09715 +414 2 4.08373 18.5038 14.7912 8.14506 -1.30426 -6.00867 +415 1 7.12802 0.652367 18.3595 35.0739 -19.2419 -26.0317 +416 2 7.40845 0.19154 17.5185 -9.63956 16.0629 26.4358 +417 2 6.18456 0.683953 18.3433 -21.3742 6.93569 3.25827 +418 1 16.0657 18.4123 14.0301 53.2891 7.60066 12.7833 +419 2 15.2177 18.2242 13.7261 -48.7282 -11.4797 -7.69178 +420 2 16.0808 18.482 14.9966 -9.66087 4.27341 -2.7923 +421 1 10.0672 4.54369 16.2573 46.2132 32.473 -7.3661 +422 2 10.9795 4.93172 16.0704 -30.9355 -10.7562 9.7222 +423 2 10.2805 3.63455 16.4071 -7.05314 -22.7581 -0.39686 +424 1 15.904 17.802 4.45553 44.7656 -19.4466 -14.3322 +425 2 16.4088 -0.0282793 4.41597 5.24747 5.32524 1.83839 +426 2 15.0633 18.045 4.74212 -51.1512 14.4852 15.4733 +427 1 6.99737 17.3998 13.7879 -47.9218 -2.31875 -13.0268 +428 2 7.40243 17.6398 14.5891 19.7576 8.98543 35.5766 +429 2 7.70074 17.2583 13.1843 23.2619 -4.97282 -20.0499 +430 1 13.2941 6.48376 6.64986 8.60711 15.0683 16.7306 +431 2 13.9993 7.1541 6.49159 -11.9149 -19.7057 -4.80273 +432 2 12.8211 6.29295 5.83939 3.46216 6.87198 -11.4398 +433 1 7.76205 2.3443 9.26472 15.7579 10.991 45.3998 +434 2 7.20759 2.25447 10.0765 8.01487 -1.94761 -18.5756 +435 2 7.26048 2.06297 8.52639 -23.6607 -10.4133 -22.8687 +436 1 15.1706 14.8583 13.6757 15.7984 -16.1031 1.44613 +437 2 15.0167 15.231 14.5413 -6.09806 3.71972 9.46304 +438 2 14.6225 15.2955 13.0407 -11.5903 11.1836 -9.13521 +439 1 9.36431 8.31687 3.74781 -9.55399 11.9025 -3.42765 +440 2 10.1518 8.60925 4.20014 9.2003 9.72282 -0.0746101 +441 2 9.3553 7.37835 3.87681 -0.285781 -17.995 1.20514 +442 1 17.7597 13.5616 16.4405 -12.156 -24.6438 9.82021 +443 2 16.8551 13.2283 16.3395 1.48334 1.58847 4.06975 +444 2 17.7289 14.3961 16.0037 5.37456 23.0458 -12.1714 +445 1 4.95841 10.6088 2.75519 -22.9294 18.7883 -14.1686 +446 2 5.66909 10.277 3.27928 16.3083 -8.75526 16.0734 +447 2 4.6114 11.3873 3.23357 6.81328 -15.8641 -4.024 +448 1 3.73362 8.35206 10.1813 3.02598 13.3252 -21.6654 +449 2 3.8939 9.27056 9.86724 -4.6548 -13.2191 9.23973 +450 2 3.49789 8.39898 11.1021 -0.178845 4.23779 13.7606 +451 1 16.0042 7.01418 6.13738 -12.6879 19.8807 -2.17242 +452 2 16.808 7.4479 6.40937 10.6213 6.47779 2.98579 +453 2 16.2019 6.09716 6.06821 5.44302 -25.895 -2.3467 +454 1 15.1221 7.07483 9.10103 -4.15707 -25.1338 32.4641 +455 2 15.7464 7.4872 9.69859 9.03801 3.43378 3.13104 +456 2 15.1481 7.58948 8.33098 1.37226 23.8896 -40.0507 +457 1 6.35284 13.0135 12.8052 -0.193314 -18.9728 -17.7547 +458 2 7.21044 12.6571 13.0708 -4.00291 0.344811 4.20755 +459 2 6.11805 13.741 13.3614 0.492624 18.505 17.8288 +460 1 12.1195 4.49733 13.0969 -26.0004 -21.5883 -29.3264 +461 2 12.1632 4.68913 14.0325 -4.53328 -3.39715 11.6105 +462 2 11.3073 3.93318 12.8667 31.5163 26.387 18.3053 +463 1 11.3554 8.17046 7.8728 -3.27026 2.45633 -4.65198 +464 2 12.0683 7.62612 7.54639 6.23155 -9.6048 -12.5756 +465 2 11.5676 8.24955 8.79484 1.17104 5.44951 18.1694 +466 1 17.1791 10.8374 7.47157 -22.685 17.097 10.0101 +467 2 17.8401 10.2117 7.26521 25.6893 -28.4186 -0.815308 +468 2 17.2004 11.4333 6.72646 -9.08817 8.64759 -4.95169 +469 1 5.26928 18.1244 11.0251 26.2987 0.0330793 2.18763 +470 2 4.69547 17.8637 11.7317 -9.61751 -4.26247 14.7568 +471 2 4.70076 18.4264 10.3375 -16.9 2.57743 -21.8459 +472 1 7.59635 17.5306 1.81531 -10.9531 4.1869 -25.2725 +473 2 7.77056 16.6988 1.31883 2.24077 21.8764 10.5056 +474 2 7.30155 18.2046 1.15131 11.3055 -17.5184 13.1347 +475 1 1.92843 12.8944 13.5862 -6.59595 -16.5477 -16.8116 +476 2 1.43666 12.2821 14.1316 -5.58333 -5.88714 5.06202 +477 2 2.04362 13.6601 14.1181 9.10211 24.5058 14.6097 +478 1 9.63922 6.76943 14.8194 -3.94612 -18.0692 3.52162 +479 2 9.76751 5.80583 15.0218 -0.27339 26.7602 -8.06829 +480 2 9.98245 6.98264 13.9392 -2.96138 -9.43899 0.82382 +481 1 15.2804 4.29771 10.7711 -7.29951 -1.41697 -0.334277 +482 2 16.1821 4.02615 11.0218 -9.71269 11.8498 1.69675 +483 2 14.9105 4.9568 11.3864 17.8049 -7.45406 -3.59162 +484 1 11.2365 6.16159 0.180514 3.71779 6.92115 0.875598 +485 2 11.3264 5.36714 18.3195 14.2335 -18.3801 -6.22284 +486 2 10.2946 6.26806 0.197414 -17.1549 12.9032 2.71424 +487 1 0.0669242 11.3685 15.0652 13.212 -6.85086 18.3683 +488 2 18.0421 11.4114 14.3938 -11.7915 7.94746 -16.0964 +489 2 -0.126536 12.1197 15.6445 1.80559 0.362507 -3.06694 +490 1 7.04679 9.22841 7.26069 23.2883 20.8536 -5.26127 +491 2 6.49897 8.58869 7.67863 -15.4435 -25.8158 9.46312 +492 2 7.95399 8.89143 7.34084 -8.97527 1.37154 -2.4384 +493 1 18.3457 15.377 12.3544 -10.4554 -0.385944 -2.00928 +494 2 0.632165 15.4053 12.1583 18.2501 2.20759 0.366712 +495 2 17.9344 15.8751 11.6412 -4.56296 -0.981709 -1.73702 +496 1 16.5292 4.37759 5.24858 18.1125 19.5767 -27.8403 +497 2 16.7661 4.20984 6.14013 0.307987 -10.9951 33.7785 +498 2 17.3779 4.70209 4.86684 -19.0742 -11.8317 -4.1687 +499 1 17.7267 3.12899 10.7335 -24.2941 -12.2101 -5.28174 +500 2 18.5902 3.43151 10.9823 20.7538 0.196381 3.18907 +501 2 17.7917 2.2294 10.3565 4.74658 11.2046 4.02468 +502 1 12.2912 0.000462328 10.1205 5.29277 -42.3116 -12.7781 +503 2 11.463 0.345322 10.3908 -30.9755 9.64408 8.62664 +504 2 12.8898 0.704281 10.2182 28.9402 34.0259 3.93413 +505 1 10.3772 9.78855 12.3993 -21.9688 -12.411 -17.7787 +506 2 11.0129 9.78765 13.1014 16.013 1.76066 13.7043 +507 2 10.1738 8.8461 12.2399 4.72709 11.7982 0.616329 +508 1 0.569471 2.8284 7.02034 6.04311 -30.2491 -2.51113 +509 2 0.820763 3.41522 7.71636 2.48105 19.4463 13.5049 +510 2 0.862153 1.97327 7.38155 -6.15059 8.48947 -7.95665 +511 1 0.371359 15.3036 6.90441 -15.8595 21.8666 50.0789 +512 2 0.449232 14.6844 7.65301 -0.190166 17.9034 -2.10351 +513 2 0.621967 14.7945 6.18679 16.5003 -37.2512 -48.0182 +514 1 17.0414 7.00877 15.2159 -22.6634 4.89001 -1.64325 +515 2 17.7376 7.6544 15.0563 8.01654 -6.9456 2.15019 +516 2 17.4056 6.16817 15.5101 9.28872 0.897926 -1.45041 +517 1 9.06316 12.4266 8.08985 69.8766 6.47542 -0.0200154 +518 2 9.44101 11.8026 7.43298 -17.7999 4.13897 6.91255 +519 2 8.14431 12.4062 8.1331 -54.6706 -8.19385 -9.80298 +520 1 1.26891 1.85581 2.9921 11.7044 -8.67905 12.4997 +521 2 0.561231 2.0509 2.38915 -6.84046 11.4219 -12.1453 +522 2 1.65109 2.68456 3.32008 -5.2596 -5.54909 -2.36563 +523 1 4.11753 15.1048 9.79523 4.78264 -4.87511 12.6416 +524 2 3.99332 15.4569 8.91057 5.07926 -2.88804 -4.85995 +525 2 5.03278 14.7822 9.88586 -9.66079 5.58119 -5.37355 +526 1 7.25278 2.18203 14.6254 -0.555581 -14.0599 -5.06396 +527 2 7.1005 1.71681 13.7878 -2.90711 2.6098 7.34806 +528 2 7.71992 2.97108 14.3713 4.55177 12.8631 -2.10328 +529 1 18.557 14.6494 2.1729 -24.7771 22.3853 -4.36836 +530 2 0.778963 15.0461 2.09778 12.8139 1.02797 3.11036 +531 2 17.9275 15.4159 2.12338 10.4684 -24.8222 2.25012 +532 1 9.97282 2.76121 12.909 0.960373 12.9666 17.7509 +533 2 9.84581 2.0662 12.2717 -5.76657 -8.74665 -14.3806 +534 2 9.17654 3.31629 12.9308 6.08178 -3.78367 -5.74316 +535 1 2.89833 8.91803 13.044 14.9503 3.68581 0.826535 +536 2 3.29774 9.80788 12.9186 -7.17545 -13.4779 0.185991 +537 2 3.62224 8.34145 13.3619 -7.75262 8.46695 -4.72395 +538 1 3.21711 8.45664 3.69888 -1.45646 11.2765 -73.7917 +539 2 3.66926 9.20612 3.219 -10.9411 -20.3742 19.6072 +540 2 3.34915 8.55803 4.60102 11.7629 13.1896 57.1484 +541 1 5.60205 7.18882 8.56127 11.7766 6.17403 -13.6051 +542 2 5.73377 6.23122 8.60856 -5.21401 3.91262 5.39773 +543 2 5.15686 7.50265 9.34977 -6.87961 -7.75657 6.1504 +544 1 14.8989 1.38427 1.96946 -15.0866 25.6457 3.84218 +545 2 14.4906 2.19786 2.32837 7.96598 -16.9425 9.74227 +546 2 14.9786 1.62425 1.05302 13.5137 -6.97514 -15.0219 +547 1 8.3539 15.1902 0.828571 -0.607384 -15.7884 -3.69873 +548 2 9.11456 14.9295 1.35098 9.06641 9.90213 6.9538 +549 2 7.64957 14.6447 1.20074 -5.27592 0.575252 -4.39528 +550 1 15.5904 1.35118 7.21966 19.131 18.1941 14.0102 +551 2 15.0458 0.788774 6.70847 -19.486 -21.9805 -16.5491 +552 2 15.0172 2.08736 7.44992 -1.58717 6.06663 4.11757 +553 1 4.99095 13.0428 18.5017 -11.814 -5.03203 -22.7016 +554 2 5.38558 13.1981 0.699871 9.67176 2.40993 22.9792 +555 2 5.69857 13.2122 17.8695 -3.662 3.61759 -0.881885 +556 1 15.3616 8.52427 18.1264 -8.5134 -8.81723 23.808 +557 2 15.7284 8.98559 17.3934 10.1937 15.818 -24.0842 +558 2 15.2728 9.20414 0.16849 -1.83009 -5.75583 -0.912989 +559 1 12.0932 3.04939 18.3516 -14.5656 24.4873 8.42937 +560 2 12.4759 2.51827 0.417994 -2.38649 -9.33387 -9.98316 +561 2 12.2916 2.69447 17.4847 9.72648 -15.0074 2.48816 +562 1 13.2068 12.6815 5.17314 -7.19784 6.47098 -0.665029 +563 2 13.7108 11.8878 4.96601 4.53767 0.295949 3.70661 +564 2 13.3847 12.9363 6.09127 2.00425 -11.4311 -4.02895 +565 1 6.06883 7.14745 0.0914664 -7.81354 22.5487 2.98517 +566 2 5.88319 8.11419 0.19427 8.4279 -22.2037 -4.79949 +567 2 5.22519 6.72532 0.292473 3.10856 -0.243494 3.48057 +568 1 17.7194 15.9325 14.9871 -5.54638 -4.40987 -28.7902 +569 2 16.9069 16.4169 14.9498 -12.3977 10.2544 17.1316 +570 2 17.7594 15.7087 14.0393 19.0068 -3.79668 12.8095 +571 1 13.1727 0.977833 16.5926 -11.6444 6.00991 -1.45652 +572 2 14.0026 0.708875 16.9779 14.0624 -0.886732 -0.671765 +573 2 12.7076 0.152182 16.4397 -1.15444 -5.20647 -2.10321 +574 1 11.0384 14.6069 7.3103 -17.4066 -34.6271 2.52502 +575 2 10.2783 14.0261 7.58336 17.6612 20.778 -3.294 +576 2 11.8174 14.0391 7.44317 -4.14385 7.222 1.39489 +577 1 17.5379 8.55913 2.08836 4.35413 -11.6997 -13.5411 +578 2 16.664 8.39738 2.48219 7.20941 -2.48593 -6.20174 +579 2 17.6519 7.91106 1.34391 -7.20398 14.5397 25.454 +580 1 12.3635 7.91649 1.96817 14.6342 -23.934 -0.413214 +581 2 11.8532 8.69875 2.12901 -10.659 13.0689 -1.52352 +582 2 11.9409 7.3888 1.27378 0.548374 7.65925 3.61612 +583 1 11.9419 14.6308 10.3966 13.4402 32.5881 48.4479 +584 2 12.2905 14.0069 9.8182 12.9115 -34.2012 -37.3181 +585 2 11.0351 14.785 10.1903 -23.9611 0.860738 -9.13817 +586 1 6.84298 6.98317 15.5594 -28.1276 -29.1686 -18.0428 +587 2 7.705 6.91496 15.176 20.6419 5.27277 -3.3528 +588 2 6.85291 7.68491 16.1747 6.25697 23.8787 22.837 +589 1 8.01998 4.63032 13.4448 -35.0292 -26.7707 -36.5428 +590 2 7.42844 4.80515 12.6548 14.5268 -5.56395 32.2217 +591 2 8.43798 5.44118 13.6312 16.8653 30.885 3.99265 +592 1 13.3984 12.173 14.3104 -3.57217 10.7678 8.64565 +593 2 13.233 11.2355 14.1881 -1.19303 -4.98427 -3.70246 +594 2 13.8945 12.4998 13.5522 0.86121 -3.67781 -4.0367 +595 1 14.7231 9.47939 7.26845 -4.38272 9.59825 17.375 +596 2 15.5232 10.0108 7.49545 -18.3981 -9.5314 -3.88615 +597 2 14.0057 9.68134 7.91225 20.1628 1.06432 -13.939 +598 1 12.7179 16.9622 3.14627 23.4566 -37.2939 -10.6207 +599 2 12.9355 17.1415 4.04114 9.03221 7.6908 26.6047 +600 2 12.0213 17.5358 2.94483 -34.3001 33.1559 -14.5415 +601 1 1.10947 7.12267 17.419 -6.10821 -8.12856 16.9857 +602 2 0.178422 7.136 17.6887 4.23762 -2.5375 0.360706 +603 2 1.14096 7.54201 16.5672 -1.29203 8.00191 -14.7545 +604 1 12.8573 5.07319 15.6916 -26.4132 -0.426227 -0.347566 +605 2 13.5067 4.42508 15.4662 18.5417 -18.6841 0.103563 +606 2 13.3354 5.89586 15.6754 6.08426 15.3432 1.29959 +607 1 2.44451 3.37888 5.09109 -12.3042 -30.7639 -30.2825 +608 2 1.89914 3.20439 5.84354 -15.8924 -6.60657 16.2411 +609 2 2.9157 4.14854 5.30475 25.2943 38.046 11.4255 +610 1 8.30318 11.1757 13.537 -17.7368 31.3122 -83.5918 +611 2 8.23756 10.9827 14.4193 9.23305 -26.2584 72.471 +612 2 8.98641 10.7011 13.0548 11.9243 -7.18625 13.6047 +613 1 12.9121 1.44799 13.2982 3.17544 -30.959 19.595 +614 2 13.5829 1.31511 12.6431 13.7174 -5.57278 -14.8203 +615 2 12.5671 2.27513 13.0597 -18.9903 37.7092 -4.23536 +616 1 6.45025 13.6395 2.14169 21.7214 -12.6454 -10.4453 +617 2 5.88722 14.0323 2.78408 -20.3944 14.637 16.9787 +618 2 7.03563 13.0797 2.67163 0.317992 1.20831 -5.89746 +619 1 15.9341 6.54969 12.734 7.51439 18.2634 -8.82177 +620 2 16.366 7.12442 12.0552 -8.93517 -14.9663 18.1444 +621 2 16.3202 6.79095 13.5987 -1.79943 -6.04596 -11.4359 +622 1 16.8134 0.715269 9.59469 1.51011 24.5111 -1.75686 +623 2 16.9773 18.4324 9.6759 -2.99022 -25.9416 6.21625 +624 2 16.4855 0.841275 8.69831 -5.26956 1.43879 -3.58435 +625 1 6.14183 11.6821 8.34851 2.12045 33.7206 2.80541 +626 2 5.25373 11.5769 8.68031 -11.2997 -2.21294 6.8592 +627 2 6.41363 10.8186 8.10997 12.8023 -29.2169 -10.6172 +628 1 2.82878 8.69633 0.366162 65.7357 7.98524 25.914 +629 2 2.25196 8.1872 18.4995 -43.1364 -19.0897 -25.1642 +630 2 2.39827 9.3921 0.850531 -20.8372 5.7472 0.329713 +631 1 10.1125 10.4546 6.55694 -3.88563 -4.31924 12.8938 +632 2 10.5628 9.81084 7.11921 -1.26662 -0.776779 -0.718706 +633 2 10.7076 10.6109 5.83303 6.58413 -0.38446 -16.1853 +634 1 6.75197 15.7318 6.59922 10.1749 2.21511 -7.15796 +635 2 7.21229 16.0038 7.38721 0.121014 2.00215 12.9298 +636 2 7.17446 16.2736 5.9175 -9.12202 -3.23328 -2.5626 +637 1 6.44006 13.071 5.66115 9.01876 9.03356 -0.68679 +638 2 6.7952 13.9213 5.9766 -6.67057 -7.15315 -1.80184 +639 2 6.02558 12.6573 6.41982 -1.29087 -3.79345 3.79648 +640 1 16.7894 12.5351 9.7661 -6.01106 14.3853 23.3751 +641 2 16.9466 11.9627 9.02496 7.22561 -5.83165 -16.8213 +642 2 17.1452 13.4178 9.59292 -0.312151 -9.66884 -5.48162 +643 1 6.11103 2.94777 2.80745 -0.0522908 21.1759 -16.381 +644 2 6.20729 3.87808 2.49328 4.01665 -19.1858 15.5438 +645 2 5.82625 2.47942 2.01203 -2.73031 -5.31149 4.59086 +646 1 10.8562 3.22295 3.2592 5.83487 -6.01133 1.10343 +647 2 10.3184 3.99141 3.45824 -8.06424 0.347936 -1.44444 +648 2 10.5285 2.8344 2.43843 -2.26863 2.18612 2.83427 +ITEM: TIMESTEP +50 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.76267 6.9614 17.9655 18.039 1.32171 0.971735 +2 2 7.88851 7.04905 18.3237 -17.7355 -1.2272 4.07533 +3 2 8.77103 6.18416 17.4071 -1.73171 -4.43635 -4.46665 +4 1 18.7148 8.30367 6.79977 -11.0979 19.7573 -45.8218 +5 2 0.340011 8.13606 5.84126 -7.49685 -0.624375 38.3142 +6 2 0.514278 7.70743 7.38333 14.5888 -19.2797 9.57425 +7 1 8.47639 18.6969 6.83361 -13.2294 -1.25401 8.78355 +8 2 9.37315 0.218195 6.58559 19.0885 2.32763 -3.91705 +9 2 7.98208 0.748711 6.39478 -2.33131 3.58411 -1.86541 +10 1 6.52812 1.78346 11.693 -34.4751 -1.18092 9.20038 +11 2 5.67737 2.21709 12.0036 34.6116 -15.9045 -8.19534 +12 2 6.27488 0.856486 11.479 2.31906 19.7771 3.09659 +13 1 7.04596 5.66579 2.40189 46.2065 -42.3734 -14.42 +14 2 6.39782 6.00892 2.95716 -37.9245 28.3982 32.5204 +15 2 6.93615 6.04049 1.54428 -8.317 15.9019 -18.5798 +16 1 16.2302 10.236 16.0835 20.9593 -16.5275 2.4245 +17 2 17.1756 10.4542 16.2372 -23.2351 0.455296 -7.02457 +18 2 15.6872 10.9657 16.3738 0.757377 12.3052 3.78761 +19 1 10.6519 14.9414 2.32488 9.23959 14.6152 1.78567 +20 2 10.6414 14.4628 3.16471 0.797937 2.29677 -5.70575 +21 2 11.1604 15.7599 2.50148 -7.89724 -14.8548 -1.26363 +22 1 17.1653 8.24769 10.628 -7.00673 -3.15457 9.83212 +23 2 16.8168 8.85992 11.2947 -1.87186 0.196375 -6.64951 +24 2 17.9222 8.68524 10.2369 7.99899 3.60318 -1.68622 +25 1 14.7266 15.9157 16.4191 -13.8739 15.1565 -8.48964 +26 2 13.7936 16.2384 16.3951 24.1732 -8.40377 0.758561 +27 2 14.8582 15.5746 17.3097 -4.06225 -5.68183 -0.795501 +28 1 12.1165 13.3951 0.497647 12.4663 -12.7582 1.83308 +29 2 11.9617 13.3954 18.1814 -7.51799 5.11576 7.21512 +30 2 11.4424 13.8646 1.00511 -0.599491 5.86198 -7.65109 +31 1 9.3022 5.46358 3.98483 37.3 9.28522 -25.3544 +32 2 8.76176 5.25183 4.70521 -26.4917 -13.7331 37.3539 +33 2 8.69012 5.59126 3.27137 -14.2398 -0.31671 -15.324 +34 1 1.75646 4.13824 11.6126 7.13571 -34.631 6.10286 +35 2 1.57168 5.01735 11.8974 -3.49495 27.0073 7.26754 +36 2 2.15491 3.66767 12.3745 -6.50879 7.63382 -13.9832 +37 1 2.03017 6.80422 8.30837 9.29028 16.8447 12.8872 +38 2 2.52076 7.32809 8.97976 -10.1379 -7.93343 -11.4013 +39 2 1.79129 5.98703 8.76166 3.66627 -1.3648 -7.3534 +40 1 5.38278 4.45139 7.96045 1.48715 2.78745 -0.615366 +41 2 5.47525 3.53905 7.69237 2.73507 -15.0654 6.73754 +42 2 4.91072 4.84535 7.233 -11.388 9.54401 -10.9371 +43 1 3.30811 2.94776 17.4802 13.944 -42.282 -21.1312 +44 2 3.9986 3.21817 16.868 2.68053 3.29728 -0.298822 +45 2 3.01647 3.72731 17.8911 -19.397 34.8415 21.3069 +46 1 7.43048 5.35311 6.10326 -4.25319 -13.0158 -27.7806 +47 2 8.09022 5.89476 6.48364 23.034 26.3027 15.5228 +48 2 6.99872 4.97144 6.84559 -15.3695 -14.0963 19.964 +49 1 9.79676 7.01231 12.0156 -14.7328 3.59156 -15.7655 +50 2 10.3705 6.43202 11.4882 -9.23999 6.31012 5.56299 +51 2 9.04301 7.2927 11.4294 23.3546 -9.34629 13.9639 +52 1 14.0089 3.6286 8.06931 13.5755 5.11429 34.4728 +53 2 14.0074 4.36435 7.46412 -2.30693 7.62473 -7.33974 +54 2 14.3705 4.00595 8.91563 -10.4749 -13.1534 -24.8623 +55 1 4.55657 17.1558 3.95973 -9.28017 -24.3455 25.7085 +56 2 5.47914 17.3407 4.055 21.0307 11.7367 -4.03215 +57 2 4.1348 17.6911 3.31263 -3.95253 16.2794 -25.0192 +58 1 16.4751 16.614 10.2504 -32.3258 -7.85569 21.4695 +59 2 15.6275 16.6356 10.7813 29.977 2.99208 -16.9651 +60 2 16.2718 15.9944 9.53771 -1.01186 4.78751 -1.5712 +61 1 1.9619 4.81867 0.319959 -10.9755 -9.70287 -18.0846 +62 2 2.61752 5.08919 0.942567 15.1261 9.15008 18.4356 +63 2 1.74644 5.61951 -0.161427 -5.07436 5.04444 -4.19633 +64 1 11.5961 13.2841 16.3358 -4.45358 14.5896 10.2849 +65 2 11.0454 12.5131 16.3954 -10.7816 -16.1685 4.94665 +66 2 12.1536 13.1064 15.5876 11.3576 1.56581 -12.6168 +67 1 10.1325 11.0245 16.8746 -17.0839 37.329 0.881875 +68 2 10.5383 10.188 16.8005 14.1256 -36.2582 -1.95739 +69 2 9.19072 10.9065 16.7053 -0.138929 -3.60954 1.11764 +70 1 11.7656 17.449 13.475 -8.50487 25.248 2.18402 +71 2 12.3632 17.1066 12.8073 4.24528 -3.45864 -2.0733 +72 2 11.8231 18.4283 13.4081 4.57434 -16.4673 0.201387 +73 1 6.41878 9.35136 12.2283 -7.50229 14.2202 21.4939 +74 2 6.8057 8.89086 11.4896 12.6266 0.651555 -6.79619 +75 2 7.09031 9.88696 12.7035 -9.91308 -10.3657 -12.0835 +76 1 16.2619 12.8358 2.69678 7.42582 31.4023 -4.83963 +77 2 17.0939 13.3284 2.51069 -14.3032 -16.3414 4.28546 +78 2 15.5824 13.5473 2.68145 7.19887 -17.4175 4.43499 +79 1 0.698809 12.6212 5.89369 35.48 3.16674 13.5988 +80 2 0.938081 12.5288 4.97754 4.92149 -4.10163 -12.4931 +81 2 18.4194 12.7439 5.90006 -39.8609 3.63618 -4.1467 +82 1 5.237 16.4363 18.426 1.65878 -0.316472 9.22308 +83 2 5.81108 15.7548 18.0954 4.21498 -13.4949 -13.2329 +84 2 5.56972 16.5656 0.670239 -4.67124 7.34541 5.05152 +85 1 0.592121 7.69947 4.15467 -58.6061 -26.6762 36.9237 +86 2 18.6393 8.0928 3.5307 -12.7545 6.31849 -14.8448 +87 2 1.4218 7.85573 3.82511 72.6481 19.3185 -25.9209 +88 1 3.11983 8.96532 6.48794 54.6199 12.7003 -22.2767 +89 2 3.76913 8.45297 6.98254 -4.7725 1.8296 2.92636 +90 2 2.27977 8.75705 6.803 -46.0396 -12.4219 19.8369 +91 1 7.29807 10.3702 16.2638 20.6686 -0.114663 -24.6428 +92 2 6.66655 10.506 15.5642 -5.16108 2.7891 -5.34334 +93 2 6.78521 10.2638 17.0451 -10.3715 -1.64006 24.8745 +94 1 11.1174 0.987619 5.00277 -7.18116 3.53088 7.25248 +95 2 11.0089 1.86145 4.60844 7.25629 1.31859 -0.585836 +96 2 10.7387 0.391071 4.35918 -2.65397 -7.99376 -8.61355 +97 1 4.35641 2.82374 13.2083 -1.43301 42.1246 -29.6721 +98 2 4.74578 3.12447 14.0221 1.91906 -0.955597 13.0676 +99 2 4.17771 1.91012 13.264 -5.21231 -41.1093 14.0839 +100 1 8.41102 10.1748 1.81577 -7.29686 12.4487 -22.3398 +101 2 8.22152 10.8552 2.46036 0.4991 6.95458 5.373 +102 2 8.69583 9.43786 2.3232 10.7851 -24.1065 14.6426 +103 1 10.4306 1.70557 15.5491 18.4702 5.47966 -9.86629 +104 2 11.3921 1.67519 15.3716 -14.7227 -5.4908 8.94093 +105 2 10.0695 2.09393 14.7416 -3.28742 -2.92827 -1.64813 +106 1 2.67775 12.9037 7.82287 3.09642 7.69249 12.8714 +107 2 3.27779 13.5956 7.51776 -0.922255 -1.64886 -5.76029 +108 2 2.01429 12.7843 7.13996 -0.0248334 -2.64481 -5.98892 +109 1 3.74038 11.6511 5.07858 19.3958 17.4162 2.05128 +110 2 3.60589 10.7736 5.39333 -4.06789 -18.6575 13.0804 +111 2 3.07486 11.8033 4.42286 -17.2397 4.77378 -8.56343 +112 1 6.72135 14.4316 16.9296 11.8603 14.2358 -0.0778856 +113 2 7.64698 14.6853 17.0511 -5.38436 -3.23295 2.03342 +114 2 6.43726 14.8986 16.1349 -2.65892 -7.20284 -3.09426 +115 1 14.1884 14.544 3.35185 -21.8252 -0.368401 10.0779 +116 2 13.5247 15.1958 3.05461 14.5314 -4.887 4.26149 +117 2 13.7567 14.0734 4.09815 10.0173 4.52685 -16.1607 +118 1 8.41325 18.11 16.0503 -13.4237 14.7481 -2.40694 +119 2 9.01353 17.4146 16.1754 14.4883 -45.0972 12.851 +120 2 9.02228 0.139466 15.7926 3.66197 31.0187 -5.55304 +121 1 4.74026 1.68368 4.91774 -8.81747 -38.2992 48.653 +122 2 3.89365 2.07173 5.09257 -16.8489 9.86366 -0.181142 +123 2 5.05165 2.08173 4.1548 23.8621 30.7653 -48.3713 +124 1 15.012 12.6397 16.4637 21.182 -20.8114 -27.7575 +125 2 14.6363 13.1316 17.1743 -19.1608 12.2632 11.0748 +126 2 14.4002 12.4571 15.7145 4.23163 12.8017 20.733 +127 1 15.7141 18.464 16.8736 -48.8091 1.63943 -48.6642 +128 2 16.4537 18.5656 17.3974 52.451 1.55627 42.8989 +129 2 15.6088 17.527 16.6934 -4.99653 -8.13868 6.26406 +130 1 1.24245 1.19714 16.5568 -3.35795 -9.15112 -9.15157 +131 2 2.06126 1.67967 16.5955 12.2536 9.19 1.95012 +132 2 0.738255 1.56007 17.2754 -9.1343 5.49748 13.2621 +133 1 18.1403 4.48045 15.9024 -8.92064 9.41796 12.6958 +134 2 18.2534 3.91822 15.1507 3.10214 -9.7063 -13.7449 +135 2 0.333051 4.53253 16.3579 6.8431 0.540548 1.72555 +136 1 12.2576 16.9773 16.1451 24.3374 26.4028 -39.8206 +137 2 11.5235 16.7559 16.6626 -39.484 -19.8089 22.2101 +138 2 11.9275 17.1263 15.229 8.36672 -7.61232 16.8746 +139 1 16.0311 2.54163 18.1267 15.2184 -17.5558 18.8253 +140 2 15.6351 3.35325 18.4083 -9.02057 20.5203 4.48377 +141 2 15.9018 2.48695 17.1953 -7.32995 1.76863 -25.4669 +142 1 6.72575 13.8191 10.1968 -9.26978 -14.9128 -14.7006 +143 2 6.45064 13.4802 11.0509 2.35225 3.79258 9.11016 +144 2 6.47529 13.1065 9.58166 7.75573 8.69288 2.20437 +145 1 10.1667 18.3423 2.73278 -21.0918 -24.4685 17.5154 +146 2 10.3808 0.422697 2.17354 8.51297 19.7321 -20.8009 +147 2 9.25877 18.0911 2.47579 12.4496 3.13566 3.08398 +148 1 3.02618 17.7182 6.12046 9.12785 6.17449 -5.85825 +149 2 2.19895 17.4959 5.67953 0.482163 3.05546 -3.6427 +150 2 3.66706 17.9189 5.4073 -11.2068 -9.39986 11.0759 +151 1 12.5962 16.8879 7.98687 8.69067 0.386489 -7.96768 +152 2 11.911 16.2378 7.93697 -12.2796 -18.2514 -9.64148 +153 2 12.3467 17.3792 8.75804 4.49939 18.0195 12.184 +154 1 14.8895 15.2713 8.19847 3.78441 6.77747 -24.1674 +155 2 14.0908 15.8092 8.10802 0.530475 -1.70182 9.59272 +156 2 15.3507 15.4528 7.3473 -4.11878 -7.96121 22.2836 +157 1 17.7044 18.2264 0.345927 53.2191 22.2557 3.1655 +158 2 18.611 17.8064 0.306571 -34.334 1.581 -6.33561 +159 2 17.9464 0.534475 0.465882 -17.8927 -21.106 -0.514669 +160 1 0.816649 10.4426 1.34739 14.8692 48.9775 -23.6448 +161 2 0.0612409 10.0129 1.68761 -29.4632 -23.0248 11.5333 +162 2 0.465717 11.2339 0.843051 15.2672 -28.7963 15.4324 +163 1 1.72991 12.2406 3.39174 -15.9976 -2.88445 -44.3457 +164 2 1.42407 11.5936 2.70825 8.45982 5.87631 22.8389 +165 2 1.72198 13.0652 2.87637 5.68226 -3.3333 12.0496 +166 1 0.611993 17.231 4.90821 -34.3512 10.3394 53.8078 +167 2 18.7649 18.0776 4.93361 14.0145 -8.94618 -14.8948 +168 2 0.320128 16.8659 5.79609 20.9887 -2.41003 -36.5782 +169 1 1.10304 0.897417 9.42158 -11.0752 -12.4205 -5.86027 +170 2 1.33193 0.471936 10.271 -7.8206 6.77035 -10.9921 +171 2 0.260273 0.49253 9.11811 18.1645 10.0729 11.6017 +172 1 16.7431 2.34345 13.2996 -3.12231 -7.25082 27.0749 +173 2 16.9139 2.55723 12.403 6.00909 8.65593 -29.5603 +174 2 16.479 1.41627 13.3001 1.0866 -1.80785 3.13205 +175 1 2.64585 15.864 12.1283 -21.2463 14.7527 -7.08654 +176 2 3.15605 15.3934 12.7599 11.6364 -10.3414 18.5671 +177 2 3.00262 15.6045 11.2815 4.79088 -2.17896 -11.8296 +178 1 16.4298 15.6598 6.07287 -23.7839 -45.9221 18.6798 +179 2 17.316 15.6562 6.39936 21.0579 5.20152 4.08476 +180 2 16.3078 16.3335 5.44341 2.1367 33.4546 -25.3893 +181 1 5.80337 5.0927 11.7988 -16.1764 10.2154 8.68093 +182 2 5.24436 5.75105 12.277 17.1169 -11.9851 -7.24057 +183 2 5.28663 4.27668 11.796 1.81497 4.13117 2.00496 +184 1 15.1635 4.86687 0.779797 10.276 15.6296 -42.8981 +185 2 15.0374 4.47718 1.61189 -4.55383 -15.7546 43.9488 +186 2 14.356 5.34586 0.597493 -2.57536 1.02491 -2.93315 +187 1 16.3458 16.3763 2.04771 3.47576 3.66541 23.8501 +188 2 16.2044 16.7006 2.97252 -3.72753 -7.68524 -25.3267 +189 2 16.7389 17.1226 1.58867 -0.552753 3.82143 -4.99822 +190 1 0.255881 4.83863 3.82235 -11.3764 -61.9515 -5.66134 +191 2 0.347221 5.7447 3.93716 8.7619 60.1171 8.48532 +192 2 0.834328 4.39842 4.45398 2.37129 4.71095 -1.99834 +193 1 2.9563 15.0569 15.1257 1.71124 8.82343 -41.1566 +194 2 2.85861 14.8634 16.033 -5.32392 -14.5435 34.6784 +195 2 2.48389 15.8911 15.0234 3.12674 0.885842 0.387353 +196 1 1.13777 14.6522 9.5263 -30.3315 0.106042 24.0606 +197 2 1.89024 14.3075 9.07024 17.4708 -15.5826 -4.95385 +198 2 0.933623 14.0402 10.2733 8.29602 9.54759 -23.1661 +199 1 13.5292 16.584 11.5416 25.6454 -21.6132 21.0377 +200 2 13.328 17.2834 10.9465 -13.4726 19.9213 -18.5602 +201 2 13.2496 15.765 11.1158 -9.99742 3.11837 -0.28929 +202 1 4.66126 1.44669 0.76776 24.0608 13.759 -10.2694 +203 2 4.19513 2.00271 0.14116 -5.95148 5.85957 -2.67997 +204 2 4.06121 0.755814 1.00952 -11.6339 -11.0076 11.757 +205 1 1.46276 18.5641 11.8468 9.16484 -20.9655 21.4802 +206 2 1.29795 0.448688 12.6433 2.09315 -1.75191 -4.75625 +207 2 1.84947 17.7191 12.1761 -6.39306 18.521 -9.12508 +208 1 11.4915 10.1299 3.99438 -29.0311 -19.3551 44.8744 +209 2 11.2201 10.4871 3.17848 -8.25775 15.5063 -35.6965 +210 2 12.4189 10.233 4.02648 37.0944 1.09916 3.99775 +211 1 8.27499 12.1796 3.66337 18.6814 -7.12196 -36.2468 +212 2 9.0689 12.5922 3.98877 11.875 7.24467 3.22649 +213 2 7.6764 12.2152 4.36849 -32.1167 2.17346 40.1921 +214 1 14.4874 4.01368 3.28039 -17.5005 -0.0616197 -21.9184 +215 2 14.9648 3.93911 4.08552 21.5727 -0.139675 21.9436 +216 2 13.7566 4.60071 3.48465 -5.84393 1.34015 1.64127 +217 1 5.62374 1.66322 7.51635 70.0554 58.4457 -44.6253 +218 2 5.02312 1.16941 7.9611 -67.4835 -53.4064 45.1295 +219 2 5.39821 1.60037 6.57846 0.425083 -1.20148 0.902483 +220 1 17.8844 1.0604 4.85627 -10.0966 -7.93422 8.12116 +221 2 18.57 1.49808 4.37578 15.6561 4.82809 -15.3219 +222 2 17.6975 1.64814 5.58583 -4.12013 1.11537 7.77052 +223 1 6.80576 9.4106 4.49942 14.9318 -4.14838 16.3077 +224 2 6.92469 9.61899 5.44741 -8.81338 -3.93454 -14.2946 +225 2 7.68422 9.10473 4.22333 -4.88591 1.73472 -0.668879 +226 1 2.61188 14.876 1.98504 -6.91902 -4.93882 19.1315 +227 2 3.25848 14.7083 2.68056 -2.68924 0.660774 0.84214 +228 2 3.12462 14.9058 1.19269 5.2127 1.18228 -19.2613 +229 1 17.303 12.9246 13.1525 10.3788 -12.5807 -3.95397 +230 2 16.4389 13.2985 13.3385 -0.36563 10.0164 -0.276732 +231 2 17.9169 13.6449 12.9311 -14.7092 -1.11942 1.9762 +232 1 14.9246 10.553 1.38722 24.8563 30.4026 18.8772 +233 2 15.5245 11.2788 1.76222 -27.4309 -28.2887 -15.3922 +234 2 14.0162 10.8271 1.54897 4.06804 -0.689498 -1.36825 +235 1 5.72717 6.70809 4.58418 -6.56467 23.581 -8.85087 +236 2 6.06385 7.62371 4.66236 -8.01259 -10.4186 -5.73866 +237 2 6.2767 6.1943 5.16785 8.48743 -6.29877 6.22452 +238 1 8.0009 8.33508 10.3687 14.1913 1.83663 -35.3126 +239 2 8.52082 9.13006 10.161 -0.0651459 -5.63876 7.89795 +240 2 7.94932 7.91253 9.48819 -6.75295 -2.00865 18.056 +241 1 13.4409 18.4268 5.72382 16.6357 0.722738 -15.7997 +242 2 12.6296 0.221713 5.47389 -5.04693 11.9449 -2.85301 +243 2 13.1936 17.8965 6.46343 -5.47963 -14.8645 21.1785 +244 1 0.0859293 2.63743 0.236192 -9.12202 -35.143 -2.56963 +245 2 17.9325 2.9505 -0.168165 -24.3821 -4.07692 -4.34214 +246 2 0.590564 3.4143 0.297916 33.333 32.0117 7.87133 +247 1 12.8395 11.0444 9.74231 45.1743 -31.9509 26.4779 +248 2 11.9686 11.0602 9.42407 -43.5447 -1.91263 -10.9888 +249 2 12.9558 10.1388 10.1456 -3.41612 23.6256 -14.6869 +250 1 0.710059 12.1592 11.0756 -10.531 -0.362272 -11.4251 +251 2 18.3753 12.1255 11.106 13.0957 4.94421 7.25875 +252 2 1.07349 12.4339 11.9177 -3.83141 1.58371 11.017 +253 1 5.10203 7.3136 13.4291 15.7719 5.5957 -0.396148 +254 2 5.6162 7.93373 12.8769 -6.75271 -3.40235 8.70115 +255 2 5.62723 7.25347 14.2483 -7.64248 -3.9813 -9.01905 +256 1 1.21129 6.85545 11.8946 29.9494 36.4661 12.0403 +257 2 0.485742 7.25442 11.415 -4.88796 -0.516932 -2.56673 +258 2 1.80546 7.64481 12.127 -26.2797 -36.2571 -7.59378 +259 1 15.5076 9.61367 12.3051 21.7085 -42.1446 -13.9552 +260 2 15.1772 10.4675 12.1584 -16.5272 42.565 -1.064 +261 2 15.3545 9.37182 13.2055 -3.21788 1.51701 18.7315 +262 1 16.6116 12.7513 5.5295 7.16384 -7.58562 22.1279 +263 2 16.3878 13.6701 5.61583 -3.61437 18.1746 3.54477 +264 2 16.4616 12.5615 4.61757 -3.38991 -5.42355 -25.0954 +265 1 6.3014 9.86096 0.0280098 12.3864 1.00447 14.78 +266 2 5.6246 10.4136 0.42972 -1.13337 -0.2267 2.50286 +267 2 7.03571 9.82087 0.686012 -15.2579 5.10695 -14.0237 +268 1 12.3034 6.12839 4.06739 18.1147 15.8957 -28.6536 +269 2 12.3348 6.66771 3.23063 -4.28261 -10.1618 29.3394 +270 2 11.5855 5.52112 3.9529 -14.8183 -8.35162 -1.01689 +271 1 0.289245 12.8118 0.17396 1.00074 4.7721 1.62068 +272 2 0.031574 13.4709 0.828681 0.933398 1.09562 1.96647 +273 2 18.4473 13.0492 18.0252 -3.3255 1.79332 -7.06642 +274 1 3.67377 18.6092 8.59256 -12.2718 12.3972 8.90671 +275 2 3.51633 18.2244 7.72678 0.0355868 -3.61867 -2.60117 +276 2 2.80982 0.36536 8.82196 13.0622 -5.69839 -0.636093 +277 1 7.44701 17.3263 4.47819 -12.2479 -42.1382 8.27198 +278 2 7.47198 18.2285 4.71954 7.46065 34.1282 3.2472 +279 2 7.59543 17.2523 3.54279 -0.328999 6.68987 -14.4609 +280 1 9.24493 17.1077 12.2387 -39.9724 15.9122 -7.56371 +281 2 9.27102 16.3677 11.6468 4.90539 -16.8252 -9.88175 +282 2 10.091 17.2207 12.6154 35.0883 -2.17581 15.9571 +283 1 13.2831 12.983 8.01599 31.7457 23.9761 -1.258 +284 2 13.3856 12.1913 8.53584 -3.88389 -9.78552 5.15809 +285 2 14.1414 13.4672 8.16531 -29.1617 -3.59582 -8.01118 +286 1 14.8948 2.98524 15.3712 -17.5751 0.764594 21.5491 +287 2 14.1876 2.34218 15.2724 -1.25262 -5.58382 2.64656 +288 2 15.4061 2.89645 14.5861 17.2961 2.13088 -20.5882 +289 1 9.89537 15.5662 16.9902 -4.09035 4.17693 9.89685 +290 2 10.2983 14.7234 16.7502 5.73332 1.10161 -2.59445 +291 2 9.67249 15.5035 17.9343 -2.60097 -1.56266 -9.87078 +292 1 11.3274 8.38795 16.5853 -21.4847 -13.5698 4.02619 +293 2 10.6433 7.93033 16.0536 12.1725 7.69909 5.41873 +294 2 11.2563 7.95351 17.4557 6.17465 6.37506 -11.4872 +295 1 3.9593 18.2162 16.7697 0.697619 -14.1615 -14.1273 +296 2 4.40283 17.477 17.2226 -3.01571 14.2153 3.03122 +297 2 3.77495 0.26362 17.3949 3.98021 5.349 11.1126 +298 1 2.22376 4.19593 8.92134 -23.2189 1.10906 -21.9008 +299 2 3.13693 4.25168 8.71451 27.6214 0.869066 -8.80864 +300 2 2.192 4.13003 9.85498 -3.77747 -6.53541 33.4183 +301 1 9.87956 10.3806 9.72418 15.1316 -34.7661 11.7533 +302 2 9.43202 11.1334 9.41625 -17.3542 37.4051 -17.5479 +303 2 10.0318 10.5223 10.6578 4.66737 -1.93825 10.7585 +304 1 9.70627 0.903434 10.8708 -16.6391 -17.8124 -8.64764 +305 2 9.32253 0.0380009 11.0933 9.22807 5.63208 7.52542 +306 2 9.08638 1.2149 10.1967 9.10725 8.78511 -0.274781 +307 1 9.19757 15.1031 10.2247 30.2853 16.2782 3.75492 +308 2 8.7691 15.7671 9.69642 -6.57671 14.9232 -6.79792 +309 2 8.58248 14.3993 10.2376 -24.9838 -23.9988 3.33467 +310 1 0.938497 9.56303 10.2766 -19.6808 1.12411 10.869 +311 2 0.864208 10.4264 10.69 -4.58503 2.29603 -0.877129 +312 2 1.8082 9.5891 9.92621 21.6362 -6.44505 -13.6115 +313 1 17.0002 4.85339 8.15215 21.2107 4.17599 -32.9154 +314 2 16.5226 5.60356 8.44909 -16.9553 23.1583 5.35412 +315 2 16.856 4.21761 8.81327 -1.81027 -27.4365 28.1652 +316 1 14.7301 14.7112 0.178334 14.6842 0.804622 -15.2869 +317 2 15.1474 15.2511 0.844024 6.42123 6.45952 11.8737 +318 2 13.9865 14.3021 0.591484 -20.7841 -7.92944 9.37323 +319 1 3.69091 11.0487 9.53568 5.98335 -8.96355 13.8332 +320 2 3.56651 11.2839 10.4631 4.16949 4.48414 3.3219 +321 2 3.23005 11.7193 9.04032 -8.2098 7.45463 -11.8198 +322 1 11.2005 10.7579 1.45634 -8.62161 -19.8695 4.90197 +323 2 11.5404 11.5862 1.17391 12.694 26.4047 -12.3165 +324 2 10.2904 10.7467 1.15081 -4.44873 -2.97897 0.910453 +325 1 13.1494 7.14877 12.735 25.4211 -2.46103 0.847156 +326 2 14.1287 7.02261 12.7655 -19.3043 2.68773 1.11168 +327 2 12.7806 6.27183 12.8763 -3.1166 -1.04351 -1.25783 +328 1 9.62343 1.89491 0.979311 -12.9604 6.63616 -29.4885 +329 2 8.7946 1.64267 0.49669 19.6199 4.62861 14.6045 +330 2 10.1494 2.42868 0.345455 -5.12075 -11.8177 11.3147 +331 1 10.6335 13.514 4.5646 -17.0056 -0.486025 -1.57099 +332 2 11.3585 12.913 4.68456 17.6411 -7.84828 -0.965736 +333 2 10.6299 14.042 5.36013 -0.769181 5.74096 10.189 +334 1 14.4133 1.73933 10.9414 -11.8391 -17.207 6.29742 +335 2 15.2077 1.35218 10.5638 5.14778 2.73806 -3.87278 +336 2 14.5015 2.69292 10.9149 5.22965 5.71868 -2.86675 +337 1 14.5722 12.1975 11.686 14.094 -1.05888 37.2495 +338 2 15.3017 12.3928 11.129 31.2021 7.92611 -10.369 +339 2 13.8916 12.0994 11.0714 -43.9062 -9.54665 -27.6985 +340 1 8.20779 5.06885 9.81189 17.2837 -27.279 -13.9945 +341 2 7.476 5.2926 10.3565 -21.7486 9.79802 13.7153 +342 2 8.11585 4.0945 9.69767 5.61634 21.6585 -4.44102 +343 1 1.51211 16.8659 18.4077 -7.21278 -21.5738 6.32543 +344 2 1.92778 17.2486 17.641 3.99023 3.9685 -12.2343 +345 2 1.4425 15.9033 18.1995 7.9863 23.2313 7.90302 +346 1 1.50475 17.27 15.3217 -52.6385 22.4638 18.049 +347 2 1.49283 18.1952 15.6793 7.67726 -26.1665 -10.1971 +348 2 0.544177 16.9836 15.4083 37.5739 4.67989 -9.3974 +349 1 3.64958 5.72975 6.08508 6.29069 -26.5723 -11.3796 +350 2 3.20343 6.25343 6.73323 -12.457 15.9806 12.721 +351 2 4.14586 6.29176 5.4852 3.70859 6.95385 1.18178 +352 1 12.4272 9.46789 14.1967 -22.2867 60.9428 4.59069 +353 2 12.8141 8.72569 13.8244 25.5413 -52.6107 -24.0302 +354 2 12.2248 9.22264 15.0865 -2.36671 -8.29514 20.866 +355 1 4.05215 15.2773 6.93811 -37.3363 -16.6714 15.1212 +356 2 3.52112 16.0418 6.69595 1.88806 4.21981 -3.16255 +357 2 4.93922 15.5036 6.7631 37.0693 10.9568 -7.31607 +358 1 0.634621 8.6113 14.9988 -1.00168 -8.57623 6.03626 +359 2 0.426563 9.53409 15.1284 -0.450123 11.8509 1.14186 +360 2 1.36493 8.60238 14.3834 7.02364 0.17651 -8.78598 +361 1 12.9488 8.28918 10.2591 -12.3232 2.05195 12.3522 +362 2 13.6164 7.77926 9.80228 8.67745 -2.84232 -3.45719 +363 2 12.9296 7.914 11.161 -0.920073 6.75149 -12.343 +364 1 15.3287 7.72887 3.53701 30.7324 40.0945 -27.1654 +365 2 14.5687 7.40616 3.08394 -23.025 -16.3354 4.19175 +366 2 15.5452 7.39964 4.39595 -10.5646 -17.2283 18.769 +367 1 17.3078 6.69366 0.0430756 19.9915 -9.88107 5.38445 +368 2 16.7705 5.94464 0.294276 -4.0765 -7.9871 3.32428 +369 2 16.6874 7.33606 18.3865 -21.7939 19.8828 -6.94939 +370 1 8.91017 6.93043 7.77699 23.4025 28.7729 -7.70378 +371 2 9.81824 7.33337 7.84479 -23.824 -15.1706 -1.9244 +372 2 8.86104 6.22236 8.40836 -0.772968 -13.4081 16.1446 +373 1 12.3843 0.611213 1.25908 1.98263 -0.697807 -4.79042 +374 2 13.323 0.393307 1.31761 -0.925839 8.32556 5.35041 +375 2 12.1237 0.465738 0.350227 -1.33982 -4.5367 -2.71568 +376 1 5.61465 15.1448 14.5392 -1.26631 -30.1046 6.25467 +377 2 4.66418 15.2406 14.6702 -0.2102 4.52428 0.84195 +378 2 5.97383 15.921 14.1393 5.11494 24.4221 -7.05072 +379 1 3.84895 6.44034 1.72963 2.7696 -8.11358 7.79979 +380 2 3.51864 7.3032 1.48291 -7.06055 11.1725 -5.60147 +381 2 3.99368 6.51729 2.68239 -0.0521329 1.22822 -5.4234 +382 1 3.90083 11.5778 12.3664 -12.9911 -8.32668 -3.5509 +383 2 4.78352 11.9371 12.4749 4.25232 1.56379 3.39016 +384 2 3.29545 12.1182 12.8978 7.28302 -2.19426 -6.07273 +385 1 5.34262 3.87885 15.873 -6.15348 -82.0204 -11.7996 +386 2 6.0076 3.23261 15.5032 -15.8888 19.1459 15.4213 +387 2 5.69117 4.71679 15.7838 27.5644 60.3601 -6.10452 +388 1 14.3156 10.2471 4.51115 -35.9806 40.7967 42.7391 +389 2 14.5125 9.92103 5.39777 -3.50802 -2.54983 -0.445713 +390 2 14.828 9.75135 3.94137 33.3968 -38.7315 -40.7643 +391 1 7.75287 17.3919 9.13705 13.5919 -13.2315 -4.02741 +392 2 6.89819 17.6363 9.44363 -21.9658 0.853712 16.3055 +393 2 7.88604 17.9611 8.38483 9.7933 6.77297 -11.9047 +394 1 4.50916 14.5069 3.91348 -1.14645 -26.1805 -53.139 +395 2 4.48781 15.3883 4.18695 -0.715057 47.311 12.47 +396 2 4.59583 14.0061 4.68593 4.03467 -28.7439 39.2156 +397 1 14.2649 7.40032 15.8248 -22.801 -12.9293 -21.4811 +398 2 15.1988 7.32934 15.7188 25.9215 -1.64325 -3.33443 +399 2 14.1282 7.83404 16.6492 -0.714938 9.98648 22.5393 +400 1 3.02257 18.338 1.93829 -9.63799 -32.7056 -36.1055 +401 2 2.55646 17.7535 1.2554 15.187 19.9859 31.9951 +402 2 2.37728 0.279403 2.32429 -11.6166 9.08866 3.80637 +403 1 7.9856 1.63208 4.58686 -21.2194 7.37107 -10.8429 +404 2 7.46714 2.08087 3.89599 -2.9365 -3.17783 11.7342 +405 2 8.82293 1.5175 4.16848 19.7493 -4.53145 -2.81354 +406 1 2.46603 14.1528 17.6814 26.4379 24.7021 -16.3984 +407 2 1.84119 13.6421 18.1459 -27.3849 -25.1212 16.5566 +408 2 3.3203 13.7773 17.9154 6.17156 -2.74614 2.81365 +409 1 0.847673 1.77812 13.8995 -29.1857 4.71799 7.40329 +410 2 0.70153 1.57851 14.8469 9.71331 1.1605 -15.3576 +411 2 18.5888 1.96886 13.5517 20.2657 -3.94578 7.10705 +412 1 4.44078 18.6823 13.9019 -16.0244 4.84661 7.61196 +413 2 5.30649 18.3093 13.8135 20.8517 -5.19628 -2.25594 +414 2 4.21344 18.5423 14.8331 -2.2181 0.553195 -4.50589 +415 1 7.17333 0.707602 18.3659 18.5924 -14.7376 -19.2949 +416 2 7.29313 0.222373 17.5065 -5.17699 16.3575 23.4569 +417 2 6.28409 1.05221 18.4099 -11.4153 -0.902781 0.0516699 +418 1 16.0458 18.3995 13.9929 19.922 2.02833 15.0786 +419 2 15.1358 18.307 13.8248 -34.099 -5.52537 -15.9309 +420 2 16.0494 18.5146 14.948 8.19193 5.7614 4.60276 +421 1 10.1078 4.56818 16.2539 38.806 25.935 -8.65561 +422 2 11.0636 4.83663 16.0361 -35.078 -16.4147 14.4025 +423 2 10.0818 3.61692 16.3176 2.43484 -11.3153 -3.34335 +424 1 15.9163 17.7591 4.46968 32.0074 -29.6155 -15.1132 +425 2 16.5099 -0.143617 4.50341 7.95185 14.4383 0.237761 +426 2 15.1003 18.0575 4.79025 -43.3278 16.7712 13.4837 +427 1 7.00774 17.4246 13.8321 -56.0949 -7.97771 -22.4327 +428 2 7.49162 17.6994 14.5684 25.5375 13.311 41.1471 +429 2 7.64463 17.2266 13.1734 23.6351 -3.93018 -21.4132 +430 1 13.2756 6.47326 6.61789 23.4956 20.1255 -14.8261 +431 2 14.0898 6.99784 6.40679 -18.3755 -16.6425 15.9473 +432 2 12.9103 6.33261 5.73881 -7.54238 -3.20295 2.17295 +433 1 7.79764 2.32743 9.30513 0.620653 -0.611916 41.3127 +434 2 7.26457 2.16571 10.1169 11.5422 6.28076 -11.6799 +435 2 7.22158 2.07024 8.60986 -14.5852 -6.72752 -26.4814 +436 1 15.1722 14.8472 13.687 6.75051 -12.1688 -2.41191 +437 2 14.9232 15.197 14.5358 -2.94711 1.82763 14.9216 +438 2 14.8185 15.4404 13.0388 -8.36185 8.62669 -11.0165 +439 1 9.38377 8.31795 3.7734 -21.5197 15.3047 -10.1967 +440 2 10.1883 8.66352 4.14356 14.5642 4.86611 3.27566 +441 2 9.4002 7.3753 3.8765 5.94621 -16.0238 5.03493 +442 1 17.77 13.5913 16.4331 -7.58631 -31.5789 18.0626 +443 2 16.8485 13.2919 16.3991 0.887673 4.05725 -0.920823 +444 2 17.783 14.4232 15.9937 -0.095827 22.773 -14.6224 +445 1 4.93053 10.5741 2.80353 -17.5831 18.6377 -10.1976 +446 2 5.6584 10.2884 3.33403 15.5926 -12.1878 10.3648 +447 2 4.56303 11.3186 3.30761 3.36544 -9.45409 -4.10473 +448 1 3.72361 8.36764 10.1215 3.29328 14.9495 -8.98506 +449 2 3.89363 9.29817 9.8724 -2.16289 -13.6958 -0.787578 +450 2 3.61222 8.39575 11.0685 -3.0862 -1.08413 10.2171 +451 1 15.9739 6.97387 6.06952 -13.2047 20.7109 0.201327 +452 2 16.7663 7.43242 6.33309 11.9845 5.69104 3.28059 +453 2 16.2425 6.10629 5.81378 6.71976 -25.6546 -0.898294 +454 1 15.1226 7.10933 9.08497 -8.54326 -39.6564 44.8588 +455 2 15.7377 7.52152 9.6861 12.0306 8.12876 4.18876 +456 2 15.1451 7.58697 8.30383 2.04885 32.3579 -51.8464 +457 1 6.29947 12.9646 12.7695 3.37722 -4.66482 -6.66232 +458 2 7.17165 12.6249 12.9809 1.24175 -10.0492 1.61343 +459 2 6.12977 13.6114 13.4445 -6.34808 15.4581 9.54933 +460 1 12.1164 4.51054 13.0962 -37.6646 -34.1548 1.17408 +461 2 12.2607 4.59773 14.0409 7.03003 6.16295 4.50476 +462 2 11.318 3.89029 13.036 30.5495 29.2935 -6.64922 +463 1 11.3767 8.15056 7.89733 -18.501 8.72492 -14.0328 +464 2 11.9999 7.57003 7.45959 11.3303 -6.40222 -0.944592 +465 2 11.6722 8.28384 8.79215 9.56916 -2.23029 14.0742 +466 1 17.1624 10.8628 7.5038 -34.939 16.2827 29.0255 +467 2 17.7665 10.1757 7.31962 29.6392 -23.074 -13.6235 +468 2 17.1223 11.4937 6.79065 1.17945 1.22203 -15.4432 +469 1 5.28569 18.1322 10.989 31.979 0.201705 -2.44437 +470 2 4.81806 17.865 11.7612 -14.4656 -7.34411 17.8618 +471 2 4.63582 18.2948 10.3295 -20.6991 2.34913 -21.9288 +472 1 7.59755 17.5197 1.78957 -4.56355 -5.70379 -23.6831 +473 2 7.90081 16.7255 1.29504 -6.23989 15.492 10.1621 +474 2 7.18064 18.108 1.12072 15.1074 -6.58967 11.1205 +475 1 1.93009 12.8809 13.5782 -3.15102 -7.76664 -18.9393 +476 2 1.45787 12.3423 14.2065 -6.90584 -5.9659 9.51664 +477 2 2.19823 13.666 14.0335 5.43227 17.0545 14.7464 +478 1 9.58089 6.76558 14.8178 3.72821 -35.8509 -10.9213 +479 2 9.75861 5.80832 15.0417 -6.66727 32.4051 0.0155959 +480 2 9.77461 6.83059 13.8656 0.408011 6.2359 8.07479 +481 1 15.2957 4.27102 10.7659 9.27088 14.9202 31.1326 +482 2 16.1322 3.95288 11.1528 -7.49935 1.06904 -21.0932 +483 2 15.0846 4.9939 11.387 -3.9034 -8.13187 -14.3813 +484 1 11.2455 6.18064 0.162868 26.0255 26.7031 14.5737 +485 2 11.4763 5.37121 18.3763 -4.81733 -21.4086 -8.3593 +486 2 10.308 6.3098 0.211594 -20.2553 -5.22819 -8.60243 +487 1 0.00824002 11.3791 15.0352 26.3856 -8.14992 32.1511 +488 2 18.096 11.5216 14.3022 -25.0888 8.62779 -34.0528 +489 2 -0.201285 12.127 15.606 2.8625 2.75044 1.90901 +490 1 7.02689 9.25213 7.27678 19.2929 16.5016 -4.78745 +491 2 6.59278 8.51389 7.67295 -14.5933 -20.8184 8.5158 +492 2 7.9603 9.00351 7.26624 -3.73747 1.30273 -1.02295 +493 1 18.3276 15.3446 12.3362 -3.78489 -4.33158 3.75643 +494 2 0.608087 15.5074 12.1532 11.0792 5.95639 -3.98767 +495 2 17.812 15.8736 11.72 0.968766 1.6464 -4.64437 +496 1 16.5183 4.40219 5.2766 -9.25512 24.5768 -59.2644 +497 2 16.7942 3.98653 6.05327 18.9035 -16.7679 44.3388 +498 2 17.2936 4.55111 4.6869 -10.7937 -7.24122 14.527 +499 1 17.7074 3.16435 10.7411 -7.07567 -19.8863 -1.17515 +500 2 18.5775 3.40914 11.0222 18.8337 10.6004 6.41913 +501 2 17.8312 2.27039 10.3862 -7.09349 4.4518 -2.20884 +502 1 12.3002 -0.0151335 10.1074 11.0606 -47.8945 -14.4391 +503 2 11.4203 0.251866 10.2671 -34.8312 14.3717 9.25421 +504 2 12.8296 0.729107 10.2725 26.3435 36.9272 6.71278 +505 1 10.377 9.78 12.4264 -19.0889 -11.9366 -11.7107 +506 2 11.0349 9.79085 13.1125 14.2042 0.527855 9.4859 +507 2 10.1856 8.83311 12.286 4.63513 11.4958 0.11243 +508 1 0.612468 2.80552 7.03105 -3.16196 -18.6605 -12.6623 +509 2 0.888173 3.44011 7.68312 3.89236 7.11247 14.3448 +510 2 0.935234 1.94488 7.34043 -2.08916 10.0979 2.30791 +511 1 0.333274 15.3197 6.88029 -14.1577 45.9776 55.0939 +512 2 0.45846 14.8119 7.69617 1.50982 5.91417 -3.14315 +513 2 0.483825 14.7581 6.18064 16.8578 -51.3136 -47.9608 +514 1 17.0479 7.0004 15.1603 7.32733 3.15391 4.0553 +515 2 17.7743 7.62519 15.0492 -4.65368 3.90748 -3.79045 +516 2 17.4843 6.26113 15.5911 -6.30626 -9.6282 -1.63315 +517 1 9.09335 12.4409 8.06571 39.5186 -12.5139 -7.54936 +518 2 9.34597 11.7249 7.45783 10.9221 9.9246 5.15013 +519 2 8.17581 12.4072 7.99758 -53.4732 7.6014 3.58329 +520 1 1.26136 1.81045 2.95361 -2.6705 2.40839 8.80735 +521 2 0.548126 2.01955 2.35817 -5.69651 1.92544 -13.4687 +522 2 1.50342 2.66138 3.33407 8.35517 -3.762 3.05283 +523 1 4.10861 15.1005 9.87028 17.6559 -3.6711 -5.25272 +524 2 3.99986 15.4157 8.96812 -4.49733 0.314881 -1.79245 +525 2 5.04559 14.8362 9.90181 -11.0653 1.71965 6.05025 +526 1 7.3044 2.18074 14.6544 -4.4599 -5.38687 1.90914 +527 2 7.13921 1.65822 13.8561 -1.41133 5.62984 3.30149 +528 2 7.58548 3.05039 14.3636 5.58134 3.87352 -5.39735 +529 1 18.5311 14.6245 2.16796 -28.4168 7.73599 -0.688338 +530 2 0.75601 15.0339 2.21782 2.27339 5.70314 -0.294719 +531 2 17.8249 15.3246 2.17516 22.0369 -13.9852 -0.651534 +532 1 9.98569 2.74939 12.8982 -9.19221 10.3282 12.793 +533 2 9.83979 2.05829 12.2602 3.07064 -9.86428 -11.8695 +534 2 9.16543 3.26718 12.8794 9.24196 0.527571 1.01071 +535 1 2.93657 8.90297 13.0427 17.8365 13.1008 0.527628 +536 2 3.20967 9.8454 12.9227 -4.18066 -20.4527 0.554358 +537 2 3.74278 8.43516 13.3493 -16.2822 5.83343 -3.94486 +538 1 3.21464 8.50963 3.72772 0.0178718 14.8284 -74.1155 +539 2 3.59865 9.33251 3.32895 -6.0017 -25.5341 4.84747 +540 2 3.33657 8.62148 4.62381 5.38554 5.83243 67.2306 +541 1 5.61344 7.20035 8.58446 -2.8239 -8.19112 0.0562215 +542 2 5.53456 6.24006 8.54079 8.61958 1.67382 -4.34837 +543 2 5.04066 7.41711 9.32304 -1.21443 9.5719 0.536432 +544 1 14.8964 1.44105 1.93253 -7.61412 -10.5809 19.4064 +545 2 14.4541 2.19461 2.37874 12.2686 -5.42452 -16.4906 +546 2 15.2548 1.628 1.06483 0.86569 15.045 -4.43663 +547 1 8.4154 15.1546 0.810786 1.70028 1.58395 -11.225 +548 2 9.17382 15.0707 1.40016 -1.99176 -3.13146 6.02583 +549 2 7.70673 14.5929 1.15135 2.54266 -0.476233 4.63029 +550 1 15.567 1.36482 7.20444 28.1778 15.3746 16.2283 +551 2 15.0185 0.765154 6.74682 -23.3742 -21.8939 -17.7163 +552 2 14.9729 1.99808 7.60632 -6.19001 12.1291 -0.330309 +553 1 5.0089 13.0207 18.4853 -18.4609 -5.74542 -15.9738 +554 2 5.42479 13.0864 0.690362 9.95106 2.52519 17.0862 +555 2 5.65544 13.3331 17.8473 1.85993 1.51979 0.712767 +556 1 15.3671 8.54929 18.1095 -8.15636 -15.968 22.0227 +557 2 15.6817 9.03573 17.3686 11.3034 18.5085 -22.2724 +558 2 15.31 9.18561 0.190372 -2.38163 -0.236806 -1.34825 +559 1 12.0802 3.07221 18.3457 4.60183 -13.894 -6.42275 +560 2 12.4859 2.4 0.260392 -4.96838 8.65649 13.1594 +561 2 12.2775 2.7013 17.4791 -3.58827 6.63097 -2.22236 +562 1 13.1993 12.6855 5.15579 5.61247 -4.39703 15.9491 +563 2 13.8115 11.9693 4.94018 -5.07495 0.365899 -6.13845 +564 2 13.2564 12.743 6.12308 -1.32671 2.90452 -5.88021 +565 1 6.08204 7.19061 0.120725 -6.90673 14.7019 -8.65455 +566 2 5.87336 8.13986 -0.0835188 5.89552 -25.7895 13.7146 +567 2 5.2676 6.79179 0.465292 5.04542 5.75855 -0.526985 +568 1 17.7014 15.9063 14.9696 22.6091 -4.25312 7.62853 +569 2 16.8618 16.3646 15.0156 -4.32677 -2.50983 -14.3551 +570 2 17.9392 15.6583 14.0532 -15.4152 10.9643 9.19951 +571 1 13.1673 0.955706 16.6058 -16.4624 13.9879 0.0318296 +572 2 14.0199 0.765403 16.9805 16.2653 -3.85138 1.37902 +573 2 12.7278 0.106773 16.5459 -0.203322 -8.12911 -4.60325 +574 1 10.9967 14.5844 7.33958 -18.0316 -21.646 7.99268 +575 2 10.1705 14.1548 7.70673 29.6081 10.2394 -10.7243 +576 2 11.7328 13.9554 7.47718 -10.5059 7.23567 0.829732 +577 1 17.5629 8.52802 2.09087 -9.01192 -26.3923 -8.78708 +578 2 16.6633 8.41226 2.4486 12.6056 4.50253 0.467713 +579 2 17.6588 7.73531 1.50133 0.834193 24.7006 12.2923 +580 1 12.3809 7.87992 1.9744 6.05515 -15.9846 -5.53898 +581 2 11.7749 8.59773 2.10936 -4.35558 14.0343 4.46215 +582 2 11.9629 7.32605 1.30246 4.89043 0.565697 0.45699 +583 1 11.9793 14.6347 10.4335 18.2405 9.923 28.253 +584 2 12.2756 14.1199 9.71871 15.2703 -21.0335 -29.0838 +585 2 11.0615 14.7405 10.2767 -32.5541 7.66631 -1.56623 +586 1 6.81522 6.956 15.5295 -17.6641 -14.7432 -7.98444 +587 2 7.71149 6.86909 15.2553 24.3623 -4.30517 -12.3513 +588 2 6.87971 7.6292 16.1782 -5.40685 18.4787 21.7047 +589 1 8.03389 4.5887 13.4155 -37.171 -3.64226 -22.5123 +590 2 7.25568 4.78495 12.82 23.9185 -7.87368 18.6792 +591 2 8.43341 5.43391 13.5743 6.319 9.72574 1.79505 +592 1 13.4002 12.1853 14.3374 -4.54681 1.91445 -1.84351 +593 2 13.053 11.3082 14.1695 -1.05297 -9.08012 2.89826 +594 2 13.8525 12.4201 13.5231 2.34057 5.70396 -2.70792 +595 1 14.6576 9.49709 7.25838 9.71531 18.8932 28.1379 +596 2 15.5128 9.94191 7.46983 -15.999 -8.53149 -8.43731 +597 2 14.0596 9.76702 7.98865 8.11873 -7.0154 -18.3951 +598 1 12.7312 16.9238 3.19475 21.2814 -46.1617 -18.4213 +599 2 12.8913 17.1254 4.09275 6.71284 11.8391 31.6773 +600 2 12.0991 17.5238 2.88672 -32.0955 36.7838 -15.6883 +601 1 1.05963 7.10571 17.4007 12.4792 -13.0695 22.2141 +602 2 0.186546 7.34268 17.7101 -8.13154 -6.52047 1.59159 +603 2 1.15324 7.46505 16.5336 -1.37945 14.6986 -20.6467 +604 1 12.8789 5.0234 15.6828 -31.729 4.63914 -0.239626 +605 2 13.551 4.37036 15.6981 25.2388 -22.1242 0.0408259 +606 2 13.353 5.8465 15.7229 6.14669 17.5754 0.411177 +607 1 2.40704 3.36861 5.12193 5.52974 -41.8871 -53.5671 +608 2 1.82145 3.26591 5.8288 -30.6852 -8.64892 41.0269 +609 2 2.78115 4.20498 5.20734 26.4804 50.2953 11.9131 +610 1 8.27515 11.124 13.5771 -2.85187 11.2881 -70.0801 +611 2 8.37295 10.8581 14.431 -1.92558 -15.2628 85.0569 +612 2 8.99363 10.6344 13.1748 6.72692 3.2721 -14.9 +613 1 12.918 1.48119 13.2724 -5.46048 -28.9446 23.2516 +614 2 13.637 1.39783 12.6661 14.6279 -0.945194 -20.1211 +615 2 12.6406 2.36931 13.1901 -10.8983 31.3672 -5.19186 +616 1 6.50945 13.6334 2.15016 9.54562 -3.73103 -23.7728 +617 2 5.85792 13.9589 2.75542 -11.9505 6.96003 17.098 +618 2 7.07728 13.0286 2.63475 0.813075 1.46302 3.43305 +619 1 15.9192 6.52891 12.704 16.1802 17.7634 -8.70325 +620 2 16.3422 7.10874 12.0232 -9.40583 -17.3352 17.4966 +621 2 16.4304 6.67694 13.5293 -11.6709 -4.5663 -12.9766 +622 1 16.8012 0.7168 9.58424 5.37965 28.6432 5.104 +623 2 16.9134 18.4317 9.69441 -4.13374 -28.9785 4.85106 +624 2 16.4797 0.860059 8.69243 -6.31121 -1.15561 -8.50241 +625 1 6.13999 11.6637 8.32406 3.84263 60.0529 3.8669 +626 2 5.34748 11.493 8.80779 -22.31 -6.18549 9.45125 +627 2 6.46273 10.8378 8.08078 19.7827 -51.2376 -16.1138 +628 1 2.82548 8.7059 0.356008 25.1404 7.14145 17.7175 +629 2 2.1872 8.20684 18.5458 -21.47 -27.2684 -27.7438 +630 2 2.28201 9.37487 0.754925 -1.41085 15.0233 10.6798 +631 1 10.1039 10.4509 6.57992 -4.79526 -6.25674 7.70278 +632 2 10.5083 9.74309 7.09516 2.94215 -0.723708 0.948173 +633 2 10.6276 10.5201 5.78606 4.97834 -0.717699 -12.6856 +634 1 6.77313 15.7547 6.63388 -5.578 -17.4503 -5.92282 +635 2 7.15743 16.0375 7.46176 7.11582 8.10879 3.23091 +636 2 7.28529 16.1142 5.89948 -1.84538 11.4125 4.1387 +637 1 6.44197 13.0281 5.69829 11.2984 8.90971 -1.05733 +638 2 6.79679 13.8886 5.97631 -5.91305 -5.55439 0.155281 +639 2 6.12445 12.6032 6.49753 -3.74834 -3.51916 3.00547 +640 1 16.7803 12.5246 9.7433 1.48678 16.9805 10.4147 +641 2 16.9869 12.0132 8.97443 1.49858 -19.0548 -12.8116 +642 2 17.3026 13.3224 9.61445 -4.02823 0.499055 5.20393 +643 1 6.14077 2.94238 2.79674 5.90568 12.9134 -1.15866 +644 2 6.37771 3.87334 2.54509 -6.86675 -27.0997 0.367621 +645 2 5.77601 2.45475 2.03942 1.6023 9.98348 0.439644 +646 1 10.8329 3.18005 3.24633 -5.48645 -3.34604 -3.46544 +647 2 10.1887 3.87164 3.40992 -1.49044 3.74393 4.82403 +648 2 10.5052 2.73309 2.45537 3.4248 -0.0323397 2.60803 +ITEM: TIMESTEP +60 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.78901 6.89398 17.9776 -3.5234 1.93788 3.89787 +2 2 7.91305 7.05712 18.3419 -1.4277 0.241332 2.63834 +3 2 8.67661 6.15674 17.3832 1.3639 -6.15529 -7.04239 +4 1 18.7561 8.31771 6.77309 10.5748 -7.50476 -33.4266 +5 2 0.457617 7.9886 5.89382 -17.7288 16.9324 23.762 +6 2 0.568724 7.76979 7.40723 1.86737 -7.24646 12.6232 +7 1 8.51532 18.7703 6.84705 0.662358 -5.68449 9.56329 +8 2 9.4329 0.211311 6.58737 4.53489 1.21926 -2.36791 +9 2 8.05203 0.803554 6.35578 -1.87482 6.91549 -4.54998 +10 1 6.50103 1.76445 11.707 -23.9337 -6.76257 7.94266 +11 2 5.68898 2.17855 12.0897 23.4576 -7.00878 -10.5629 +12 2 6.21872 0.874053 11.3985 3.54415 20.4784 6.13886 +13 1 7.00577 5.62696 2.40487 20.8008 -18.6778 -13.9491 +14 2 6.3381 5.93149 2.99593 -12.7158 11.2498 18.9927 +15 2 6.96044 6.19487 1.63998 -3.33571 5.44078 -9.1088 +16 1 16.2317 10.2379 16.0906 -2.65398 7.02849 4.45196 +17 2 17.1094 10.623 16.0697 3.52116 -7.47169 -6.62031 +18 2 15.6835 10.996 16.3292 -1.12895 -7.31017 -0.603728 +19 1 10.664 14.9341 2.30567 13.0251 3.56406 6.3158 +20 2 10.7336 14.2976 3.03428 -5.34804 6.23285 -3.50086 +21 2 11.2229 15.6743 2.58509 -4.07292 -1.48419 -0.585019 +22 1 17.1728 8.23947 10.7128 -1.64499 -1.99855 0.608593 +23 2 16.6728 8.84067 11.2819 0.316783 0.889357 -0.63917 +24 2 17.9322 8.74349 10.3965 1.71935 0.329185 -1.07247 +25 1 14.697 15.9473 16.4368 -13.7705 -0.197196 -7.11694 +26 2 13.7879 16.279 16.3001 13.6207 -4.8592 3.02749 +27 2 14.6438 15.4158 17.2461 5.07545 7.5417 -4.99128 +28 1 12.1134 13.367 0.528093 -6.39608 9.01831 -4.72995 +29 2 11.8173 13.4954 18.2644 6.74141 -8.66363 -5.87361 +30 2 11.5587 13.987 1.01769 3.38254 -3.71164 8.60635 +31 1 9.30318 5.47999 3.94883 35.8178 1.45581 -2.5285 +32 2 8.76671 5.2044 4.67379 -16.9173 -4.15595 18.9992 +33 2 8.71572 5.58687 3.21666 -20.2172 1.55363 -14.8227 +34 1 1.70529 4.08306 11.601 -3.00308 -9.11056 -2.97947 +35 2 1.52513 4.97184 11.9147 2.37337 9.05749 0.600173 +36 2 2.22567 3.63839 12.2786 -1.82607 -0.283286 1.9059 +37 1 2.04499 6.82744 8.26893 9.18028 14.0429 7.96475 +38 2 2.5896 7.29904 8.93262 -11.3816 -6.25496 -6.31442 +39 2 1.81536 5.98181 8.67357 4.33854 0.450625 -3.71013 +40 1 5.3656 4.4774 7.93824 1.44041 9.72132 7.59831 +41 2 5.44269 3.52851 7.84762 -1.19648 -12.0175 -6.62376 +42 2 4.92598 4.83778 7.16432 -9.0894 -3.97332 -7.9273 +43 1 3.32251 2.9413 17.4443 0.538374 -34.3486 -6.77872 +44 2 3.98642 3.24962 16.8336 8.9197 7.73227 -3.39959 +45 2 3.04976 3.68399 17.9526 -12.2781 23.4468 13.5982 +46 1 7.437 5.38423 6.13063 5.01567 -0.272219 -26.6536 +47 2 7.97737 5.94965 6.66546 10.8347 10.076 12.8667 +48 2 6.99068 4.78917 6.71033 -9.3836 -11.0864 17.8628 +49 1 9.80479 7.01238 12.0379 -9.46641 4.39554 -21.4508 +50 2 10.3276 6.40912 11.4906 -4.30802 3.34771 7.14548 +51 2 9.13044 7.38666 11.4225 10.4612 -8.54147 15.485 +52 1 14.0024 3.65677 8.07153 1.90613 10.1899 13.6881 +53 2 13.9361 4.48059 7.56554 -1.4656 -7.0627 2.39316 +54 2 14.1946 3.93561 8.9889 0.417494 -3.38136 -15.0381 +55 1 4.51888 17.1453 3.95588 7.87944 -4.67708 3.20643 +56 2 5.41436 17.4585 3.90856 16.3959 1.38908 8.05638 +57 2 4.13204 17.4705 3.15493 -16.1768 7.51082 -11.5461 +58 1 16.4506 16.6012 10.3314 -28.9812 -6.12917 4.01051 +59 2 15.5905 16.5574 10.8183 20.4446 2.48532 -11.9951 +60 2 16.2667 16.1387 9.49338 0.364513 2.67256 9.91326 +61 1 1.97065 4.79938 0.260671 -8.10245 -17.5737 -13.0373 +62 2 2.41281 5.12274 1.03667 10.218 10.6244 9.40508 +63 2 1.8267 5.54768 -0.321227 -3.59337 9.6389 -0.147197 +64 1 11.5035 13.2586 16.3577 -0.713967 20.2415 12.8794 +65 2 11.0441 12.4305 16.4814 -6.19498 -9.28579 -2.23027 +66 2 12.0754 13.1484 15.6021 5.65191 -4.41955 -9.63321 +67 1 10.1276 11.0105 16.8449 -6.46201 16.5427 1.83518 +68 2 10.5556 10.1721 16.794 12.0656 -22.7421 -1.13044 +69 2 9.20289 10.8171 16.6996 -9.212 1.56961 -0.130134 +70 1 11.787 17.4505 13.4822 -3.74088 11.88 -4.97071 +71 2 12.2373 16.9277 12.8063 6.56705 3.4706 4.72845 +72 2 12.0251 18.3805 13.3063 -1.30808 -7.68873 2.97322 +73 1 6.42132 9.37259 12.2366 13.1698 8.24141 3.19081 +74 2 6.99069 9.01867 11.5406 -12.3498 -0.982732 4.41902 +75 2 7.03807 9.88277 12.7853 -8.70879 -2.27031 0.0855326 +76 1 16.2815 12.8722 2.70224 -2.02351 7.50879 0.830271 +77 2 17.1172 13.3658 2.56775 -16.1548 -5.18742 1.80773 +78 2 15.5334 13.5108 2.69253 18.3367 -6.33955 1.64103 +79 1 0.729913 12.6587 5.89268 5.90957 5.27776 3.54404 +80 2 1.01336 12.4973 4.99287 4.32656 -0.558571 -7.43154 +81 2 18.4322 12.7877 5.81211 -15.2269 -3.44557 0.704235 +82 1 5.2582 16.4249 18.4194 -10.384 10.1199 -1.35479 +83 2 5.6864 15.6785 18.0038 6.48963 -9.24773 3.62069 +84 2 5.52942 16.4885 0.694307 6.00107 -3.50652 -0.438993 +85 1 0.618748 7.72132 4.16911 -57.0293 -28.7954 36.7096 +86 2 18.6577 8.06272 3.52122 -10.6934 7.30065 -13.2418 +87 2 1.44908 7.88182 3.83946 68.942 18.8036 -26.9673 +88 1 3.13476 8.97804 6.4725 9.50813 11.9402 -13.0637 +89 2 3.74054 8.49646 7.01761 11.8689 -6.06991 10.2621 +90 2 2.28514 8.86225 6.86989 -19.244 -2.30506 4.89646 +91 1 7.29998 10.3842 16.2581 17.8205 -0.109318 -17.8263 +92 2 6.62843 10.5749 15.608 -5.58859 2.04705 -1.34953 +93 2 6.87201 10.3756 17.1052 -6.43011 -2.48695 12.6131 +94 1 11.0863 0.954938 5.00203 0.851153 5.26347 3.05665 +95 2 11.191 1.83687 4.62341 -3.02583 0.75042 -0.451702 +96 2 10.8235 0.406956 4.25776 -2.05383 -4.79736 -1.16032 +97 1 4.33613 2.85707 13.1911 1.54519 27.1095 -5.33994 +98 2 4.57692 3.1724 14.0657 0.352889 6.79614 0.336856 +99 2 4.2364 1.93118 13.308 -7.70759 -34.1778 4.58716 +100 1 8.4203 10.2079 1.80876 2.06346 -1.14808 -20.454 +101 2 8.303 10.9031 2.4489 -3.41662 7.51624 10.9075 +102 2 8.71506 9.44854 2.30018 2.97787 -12.0816 9.03727 +103 1 10.3977 1.70625 15.5267 1.73644 2.79304 1.06494 +104 2 11.3647 1.6343 15.5026 -8.09264 -2.44943 -3.11689 +105 2 10.0867 1.93234 14.6348 6.55478 -0.658466 2.12488 +106 1 2.65181 12.9273 7.85805 -0.311785 2.06689 -1.07798 +107 2 3.23228 13.5447 7.39928 3.74905 0.741997 1.40009 +108 2 1.98379 12.6968 7.20259 -0.999427 -0.794231 1.07688 +109 1 3.77953 11.641 5.00453 4.18201 7.36008 7.19136 +110 2 3.61117 10.803 5.43181 -1.00449 -4.29555 7.12479 +111 2 2.98088 11.8656 4.52857 -4.84381 -0.0516249 -5.594 +112 1 6.70671 14.4383 16.9441 -2.88793 7.65462 4.66357 +113 2 7.46032 14.9632 17.2378 1.25427 -2.15328 -4.6823 +114 2 6.29331 14.8741 16.1864 7.83964 -2.53039 -3.71142 +115 1 14.1974 14.5272 3.32557 -8.64957 0.126228 1.77541 +116 2 13.6145 15.2324 2.99689 6.18241 -4.15847 9.95625 +117 2 13.7792 14.1343 4.11346 2.7139 4.36583 -10.9531 +118 1 8.49626 18.0895 16.0579 -56.9361 5.6973 -1.31016 +119 2 8.97799 17.2887 16.1101 31.3098 -20.0295 7.70991 +120 2 8.99116 0.248943 16.0582 28.7181 13.2998 -3.6499 +121 1 4.72072 1.70195 4.90499 9.17194 -24.9679 14.1726 +122 2 3.98364 2.22531 5.16555 -23.8501 10.7625 5.04957 +123 2 5.10611 2.17516 4.19081 15.0133 13.348 -19.3674 +124 1 15.0233 12.5839 16.4881 -18.3113 17.2758 -0.569629 +125 2 14.531 13.0978 17.1312 10.6463 -2.17552 11.3526 +126 2 14.3728 12.5238 15.7796 8.99848 -7.00837 -8.88439 +127 1 15.6995 18.4783 16.8755 -18.8856 10.9503 -24.4051 +128 2 16.4938 18.4127 17.3644 26.3461 0.942046 24.9737 +129 2 15.418 17.5728 16.7613 -4.49112 -11.2036 -1.17338 +130 1 1.28835 1.23059 16.5761 -5.93248 -0.138309 0.14802 +131 2 2.13994 1.64325 16.7078 7.79309 6.58334 -0.470261 +132 2 0.740967 1.66098 17.2372 -5.253 -1.12337 3.85618 +133 1 18.1629 4.44327 15.9115 -6.79632 -1.27318 -1.28488 +134 2 18.1308 3.86521 15.1462 0.0573414 -0.0912133 -1.44422 +135 2 0.437875 4.54116 16.1499 5.78898 1.89854 1.50737 +136 1 12.2373 17.0002 16.1546 0.545523 9.79929 -13.3931 +137 2 11.4461 16.6427 16.5433 -11.0844 -6.7728 9.10484 +138 2 12.011 17.1373 15.2222 3.0182 -2.09591 3.06353 +139 1 16.0678 2.55904 18.1722 10.2246 -6.29614 14.7907 +140 2 15.8342 3.46829 18.3235 -8.81825 14.1289 4.59946 +141 2 15.8732 2.39245 17.2622 -4.4601 -2.08833 -19.809 +142 1 6.72425 13.805 10.1648 -2.60578 6.66979 -6.33116 +143 2 6.49371 13.5045 11.0525 -0.564993 -6.25943 -2.37403 +144 2 6.44263 13.1457 9.51237 3.71898 -2.3263 8.04067 +145 1 10.1796 18.3897 2.72456 -2.84724 -9.82946 6.47371 +146 2 10.454 0.395639 2.08514 4.83004 8.04726 -9.16723 +147 2 9.37175 18.0281 2.35385 -6.15379 0.681222 3.71385 +148 1 3.03584 17.7169 6.12875 -8.09623 -9.32203 -7.45056 +149 2 2.18289 17.4189 5.74043 17.1828 11.6191 3.33552 +150 2 3.689 17.6882 5.40781 -11.2408 2.0569 5.59443 +151 1 12.6056 16.8615 7.96971 24.61 3.09247 -20.49 +152 2 12.0094 16.1192 7.91607 -18.906 -3.75998 3.49802 +153 2 12.4208 17.4479 8.69718 -9.87831 1.59818 13.2946 +154 1 14.8851 15.258 8.17849 4.86996 1.69705 3.53461 +155 2 13.9994 15.6489 8.25275 11.2692 6.96129 -5.86816 +156 2 15.346 15.6481 7.40987 -12.7499 -9.2219 7.50011 +157 1 17.7579 18.2305 0.335063 13.8809 -6.66068 -7.77561 +158 2 18.5388 17.6427 0.115787 -18.9695 29.962 7.44433 +159 2 18.0215 0.522838 0.460167 3.90753 -19.2563 -2.82208 +160 1 0.789759 10.4825 1.35847 3.51968 14.2812 -7.72333 +161 2 0.0798625 9.88631 1.6077 -6.45512 -1.46576 0.207918 +162 2 0.407025 11.2033 0.810215 7.48025 -15.8311 11.8414 +163 1 1.75759 12.251 3.36651 -3.2997 0.800224 -5.24767 +164 2 1.53389 11.5715 2.69671 0.947411 14.52 5.02147 +165 2 1.90006 13.112 2.93145 -3.03991 -14.1386 -4.6936 +166 1 0.626528 17.2392 4.94747 0.535799 -10.8391 4.53682 +167 2 18.8821 18.137 4.96158 -2.27873 -17.8214 11.6149 +168 2 0.354378 16.6324 5.68648 2.97307 28.5848 -17.7586 +169 1 1.10952 0.863641 9.39152 -13.7339 -4.40866 12.9037 +170 2 1.31873 0.587529 10.3088 -1.45288 2.90017 -16.0983 +171 2 0.209028 0.525909 9.24512 10.3392 4.25606 -0.349363 +172 1 16.7392 2.34887 13.3076 6.86896 9.31967 14.159 +173 2 16.9447 2.54868 12.3949 -1.60073 1.25233 -7.99088 +174 2 16.5723 1.40956 13.3727 -4.20045 -10.3799 -4.26178 +175 1 2.67499 15.8791 12.0838 -15.6649 13.6026 18.6328 +176 2 3.08767 15.4473 12.8331 1.25238 -1.62775 -1.314 +177 2 3.09072 15.5563 11.2931 8.09534 -6.35014 -12.1736 +178 1 16.4274 15.6453 6.10859 -17.0431 -16.804 0.948824 +179 2 17.3058 15.6768 6.44562 21.0308 -4.79075 10.9 +180 2 16.4023 16.3397 5.46924 -8.03031 15.1286 -15.2988 +181 1 5.80151 5.1106 11.8034 -9.99749 12.6805 7.50019 +182 2 5.41461 5.91177 12.2246 6.41162 -14.9692 -6.22456 +183 2 5.12172 4.42339 11.8362 4.25931 3.80702 2.95737 +184 1 15.1575 4.86793 0.802761 22.7174 4.42582 -27.0135 +185 2 14.9254 4.50834 1.64009 -5.31496 -5.26411 26.4075 +186 2 14.3858 5.30472 0.469017 -12.1413 5.82456 -3.82743 +187 1 16.3769 16.3844 2.01422 -5.72057 14.22 1.10565 +188 2 15.9278 16.7493 2.80314 10.8683 -6.01604 -9.24812 +189 2 16.773 17.1531 1.56448 -5.22082 -7.76197 3.40899 +190 1 0.23965 4.83003 3.84895 -16.8427 -30.7507 -16.2196 +191 2 0.252698 5.75131 3.99923 2.34384 38.0203 4.84997 +192 2 0.859131 4.45396 4.45569 14.7994 -7.19156 9.40612 +193 1 2.95205 15.0559 15.135 12.255 2.89982 -34.0079 +194 2 2.82691 14.77 16.0276 -6.33331 -2.96333 21.8089 +195 2 2.70057 15.9867 15.0833 -9.42631 -1.00353 7.2626 +196 1 1.12786 14.6523 9.50314 0.137917 -12.6668 4.07712 +197 2 1.90226 14.1941 9.14772 -4.18616 2.58129 -2.64264 +198 2 0.826039 14.044 10.1958 0.138103 8.11094 -6.03497 +199 1 13.5191 16.5585 11.5327 7.73147 -8.17374 8.97592 +200 2 13.1298 17.2703 11.0385 -2.21772 17.726 -8.86187 +201 2 13.0359 15.7976 11.2032 2.83922 -8.38127 -1.58332 +202 1 4.66669 1.44213 0.750789 16.1276 9.43437 -4.32571 +203 2 4.14083 2.03292 0.213208 -5.20243 5.56453 -6.36037 +204 2 4.0469 0.85314 1.17877 -1.04658 -3.40534 3.74731 +205 1 1.47829 18.5621 11.858 5.51121 1.25702 19.3245 +206 2 1.35114 0.550992 12.5892 2.53269 -8.70306 -5.34898 +207 2 2.06733 17.8728 12.2103 -6.7512 4.69931 -6.32602 +208 1 11.4685 10.1386 3.99675 -31.6511 -19.8648 40.1611 +209 2 11.3534 10.4173 3.11507 -1.88937 16.5167 -32.0622 +210 2 12.3922 10.1317 4.15588 31.92 0.339396 6.83567 +211 1 8.2329 12.185 3.6562 14.6677 -4.21505 -16.0366 +212 2 9.0609 12.5679 3.94713 7.11932 4.3628 2.52934 +213 2 7.63223 12.3212 4.36927 -17.6963 1.05811 24.4992 +214 1 14.5368 4.0151 3.29112 -13.123 -7.80297 -23.8392 +215 2 15.0981 3.94713 4.04639 13.729 3.5857 20.4451 +216 2 13.7669 4.51912 3.55347 -6.0046 4.6829 5.42155 +217 1 5.65486 1.65777 7.52148 58.4475 40.9395 -13.9317 +218 2 4.99661 1.25201 7.99959 -53.8788 -37.1346 38.2946 +219 2 5.51095 1.40377 6.61889 -5.49301 1.61126 -19.8188 +220 1 17.8901 1.045 4.84749 -9.94718 -16.9222 0.488244 +221 2 18.5122 1.52388 4.30334 5.34684 7.49098 -3.2278 +222 2 17.6047 1.57034 5.59464 4.63979 8.2364 3.24002 +223 1 6.81309 9.39039 4.50819 3.0131 -8.49785 6.19054 +224 2 6.80308 9.57416 5.46384 1.81054 -3.72037 -9.62081 +225 2 7.68859 9.02244 4.29465 -5.74329 4.97879 4.89484 +226 1 2.5752 14.8387 1.99973 -14.8295 0.871449 -1.75437 +227 2 3.26878 14.7632 2.65166 10.803 -1.54702 2.65568 +228 2 2.97003 14.8559 1.12279 1.99123 -2.02101 2.0261 +229 1 17.298 12.9204 13.1492 -3.4846 16.1956 -6.51124 +230 2 16.423 13.308 13.3278 8.68723 -6.18077 0.438899 +231 2 17.8438 13.7012 12.9334 -6.61166 -12.0077 2.21466 +232 1 14.9034 10.5534 1.40093 -1.35277 29.2651 19.5565 +233 2 15.388 11.3453 1.77149 -13.4573 -26.0533 -12.1606 +234 2 13.9634 10.6773 1.62965 16.0361 -2.08776 -5.28169 +235 1 5.72986 6.65162 4.58435 -17.0557 15.5593 -6.14164 +236 2 5.84842 7.61417 4.55049 3.33824 -4.32419 -0.681988 +237 2 6.28697 6.32726 5.29234 8.09232 -2.61709 -0.816212 +238 1 7.99944 8.35521 10.3848 17.9936 -2.63811 -6.27588 +239 2 8.59251 9.07404 10.0893 -6.48701 -11.154 -5.32581 +240 2 7.88909 7.71789 9.66296 -2.42609 11.6503 -0.200638 +241 1 13.4241 18.44 5.69275 23.5538 0.0525075 -9.71433 +242 2 12.6953 0.391603 5.53139 -12.0458 3.72648 -1.32391 +243 2 13.2482 18.017 6.52624 -8.74326 -11.7295 10.7578 +244 1 0.0158155 2.64508 0.27395 14.5716 -58.678 15.8132 +245 2 17.7841 2.79898 -0.0392974 -21.1138 14.4347 -10.6776 +246 2 0.56739 3.397 0.238244 13.7063 38.8805 -4.38724 +247 1 12.8888 11.0203 9.74081 14.4921 -25.5472 6.65601 +248 2 11.9442 11.0265 9.60333 -9.9467 -3.56544 -1.05488 +249 2 13.1018 10.1085 10.0646 -8.85698 19.3484 -7.35591 +250 1 0.676749 12.1402 11.0769 -15.7222 13.4662 19.3247 +251 2 18.361 12.1632 11.2371 5.51909 -2.16069 -8.49445 +252 2 1.03381 12.419 11.9274 8.68848 0.134808 -1.80861 +253 1 5.1281 7.32638 13.4074 12.574 7.81643 0.126088 +254 2 5.56178 8.11083 13.0117 -0.574951 -12.9077 2.36295 +255 2 5.67541 7.10745 14.1812 -7.25639 3.83801 -6.5213 +256 1 1.19691 6.83481 11.9192 5.63437 23.0857 0.0567084 +257 2 0.430704 7.22717 11.4609 12.0202 -4.44614 6.83847 +258 2 1.80476 7.59103 12.1282 -18.5438 -19.7012 -5.0003 +259 1 15.5112 9.6605 12.308 7.39931 -23.3592 2.14975 +260 2 15.3284 10.5626 12.1388 -11.1565 28.2269 -10.7029 +261 2 15.46 9.608 13.2546 2.72926 -7.26454 12.4411 +262 1 16.5981 12.7055 5.55132 5.93792 -6.99565 4.13948 +263 2 16.3871 13.6216 5.72312 -3.40713 11.8574 1.85996 +264 2 16.4508 12.5854 4.61105 -1.1211 0.407027 -8.19974 +265 1 6.341 9.80883 0.0188309 -5.87145 18.2236 11.3739 +266 2 5.58583 10.3592 0.271383 3.51693 -3.70717 1.01998 +267 2 6.97723 9.90576 0.746734 -2.19026 0.0209431 -7.09875 +268 1 12.2976 6.11648 4.05009 -7.99316 6.14403 -18.1211 +269 2 12.258 6.83685 3.38221 3.50754 -15.1435 11.6411 +270 2 11.4736 5.62673 3.91242 4.22123 1.1153 4.56647 +271 1 0.341758 12.8367 0.152932 -4.41368 -4.71323 -6.18075 +272 2 -0.071293 13.3938 0.818389 4.38543 6.64898 2.3316 +273 2 18.4831 12.9746 17.9873 -4.56942 3.87447 -1.94524 +274 1 3.61813 18.6313 8.61443 0.661139 8.76689 2.03667 +275 2 3.46056 18.3752 7.69711 -0.554223 -6.30588 2.24303 +276 2 2.77043 0.354615 8.90695 5.13325 -4.08936 -2.3138 +277 1 7.42355 17.3409 4.4768 -7.56741 1.42105 -0.716546 +278 2 7.51902 18.2689 4.68925 3.30463 5.13228 6.51734 +279 2 7.58206 17.32 3.5353 -0.521854 -4.80047 -8.50069 +280 1 9.24832 17.1301 12.2139 -13.1815 7.8308 -4.22869 +281 2 9.33905 16.301 11.7591 -2.0028 -14.1862 -9.75618 +282 2 10.0447 17.2202 12.718 16.3553 3.99578 13.5609 +283 1 13.2894 13.0415 8.03267 8.35671 10.0486 -9.41069 +284 2 13.3695 12.1786 8.4589 5.84428 6.69767 4.94138 +285 2 14.1604 13.5085 8.0433 -18.6948 -10.3528 3.9365 +286 1 14.8481 2.99092 15.3927 0.856118 4.40098 19.7153 +287 2 14.1706 2.3196 15.3374 -5.14829 -8.82459 -5.54141 +288 2 15.3789 2.92995 14.603 5.00888 -0.952448 -11.2281 +289 1 9.90287 15.5907 16.9887 3.86064 7.54266 0.708681 +290 2 10.4376 14.8321 16.7196 -3.05759 -5.14225 0.11478 +291 2 9.69704 15.4836 17.9287 -2.19155 -3.5869 -5.21272 +292 1 11.3068 8.44228 16.6046 -8.18504 -5.87812 -2.49231 +293 2 10.7375 7.86962 16.0559 4.371 7.7216 8.33293 +294 2 11.2933 8.06373 17.4959 1.16379 -1.60832 -8.83864 +295 1 4.00007 18.2264 16.7774 4.24494 10.2639 17.5421 +296 2 4.56172 17.6396 17.2965 -1.57319 -6.32646 -5.9019 +297 2 3.85664 0.302165 17.4089 -1.12143 -0.586814 -11.7526 +298 1 2.2479 4.22742 8.91978 -15.7964 -0.236851 -9.315 +299 2 3.17417 4.26053 8.71033 14.3134 -0.385935 -1.23962 +300 2 2.16897 4.01078 9.84529 1.80454 -0.809508 12.1296 +301 1 9.87751 10.3883 9.74788 10.9603 -30.3507 -6.41167 +302 2 9.55849 11.2198 9.44401 -12.062 25.9436 -6.06801 +303 2 10.0779 10.4258 10.6774 1.92757 5.46095 17.7276 +304 1 9.69765 0.927205 10.8701 14.9831 -0.992619 -3.75191 +305 2 9.43595 0.039964 11.1566 -10.0783 4.56951 -4.94264 +306 2 9.12787 1.25731 10.1583 -1.53115 -8.98556 4.28196 +307 1 9.19006 15.088 10.2066 22.8811 13.4843 7.03893 +308 2 8.82905 15.9231 9.90375 -5.23887 5.212 -7.88342 +309 2 8.4517 14.4971 10.2333 -16.9878 -12.2258 -0.936878 +310 1 0.910091 9.64474 10.2618 6.35784 -25.2235 -17.0921 +311 2 0.848571 10.4636 10.7331 2.68282 16.4495 1.28733 +312 2 1.6853 9.71195 9.67503 -11.8234 -0.16557 12.5577 +313 1 17.0493 4.85425 8.1315 23.124 -12.0189 -22.071 +314 2 16.5036 5.57379 8.38464 -19.6085 19.0848 9.20549 +315 2 17.0051 4.2127 8.82658 -1.69519 -7.20825 12.6053 +316 1 14.7684 14.7087 0.123438 -2.69691 -12.5371 -11.3918 +317 2 15.061 15.3506 0.758659 10.1685 10.0196 13.4831 +318 2 13.9556 14.337 0.462955 -8.28455 -4.39651 5.72223 +319 1 3.75153 11.0481 9.53582 4.71209 -10.2499 1.98044 +320 2 3.63189 11.3357 10.4456 -0.734234 5.70871 5.17654 +321 2 3.24354 11.632 8.96907 -2.43681 8.8531 -2.47663 +322 1 11.2519 10.7463 1.5017 8.48932 -12.5201 -0.266865 +323 2 11.5908 11.5519 1.12329 1.64528 14.0457 -7.10687 +324 2 10.3311 10.688 1.26079 -12.3399 1.77059 -3.9568 +325 1 13.1496 7.17281 12.6854 5.50111 -7.8338 2.87732 +326 2 14.101 6.95885 12.7444 -10.2033 1.82309 -0.47089 +327 2 12.6663 6.34751 12.851 5.63542 3.55 -1.50526 +328 1 9.61828 1.90104 0.967862 -1.73511 6.80555 -16.7575 +329 2 8.75126 1.82608 0.511852 18.7109 -2.38487 5.6602 +330 2 10.2637 2.29933 0.349253 -13.3131 -4.11214 4.99441 +331 1 10.6435 13.4896 4.54607 -8.3754 1.2658 -1.96254 +332 2 11.4795 13.0515 4.69791 8.28938 -6.58305 0.731496 +333 2 10.5798 14.1432 5.24738 -1.32643 -0.553656 5.74704 +334 1 14.4543 1.71115 10.9546 -7.69161 -4.81009 -3.91494 +335 2 15.2136 1.28396 10.5547 4.80162 -2.13195 -1.67599 +336 2 14.6015 2.65135 10.8079 -1.60778 0.935868 6.54178 +337 1 14.5384 12.1186 11.6682 4.42158 0.0609916 50.1985 +338 2 15.3244 12.3738 11.2188 19.3883 10.0258 -22.7848 +339 2 13.838 12.0043 11.0592 -19.2299 -5.1918 -28.9193 +340 1 8.19636 5.07775 9.81895 6.92668 -2.08004 -5.22277 +341 2 7.38544 5.24812 10.3055 -3.33886 -3.05544 1.61921 +342 2 8.19204 4.12852 9.59915 -2.53054 10.0553 1.98192 +343 1 1.48663 16.8897 18.439 7.38955 -7.44055 -8.00122 +344 2 1.97341 17.2271 17.6702 -6.10601 -1.16576 3.12224 +345 2 1.43805 15.9298 18.2902 4.85843 10.0488 4.15854 +346 1 1.49392 17.3013 15.324 -13.7543 10.7593 4.06087 +347 2 1.44447 18.24 15.6259 -3.67575 -24.1287 -4.86768 +348 2 0.590882 16.9129 15.3122 14.6177 13.551 2.26757 +349 1 3.61646 5.75696 6.06482 3.05275 -16.2413 -2.75756 +350 2 3.17 6.32551 6.68313 -10.4039 6.81614 9.87761 +351 2 4.1613 6.3181 5.51248 5.12466 2.54076 -5.58469 +352 1 12.4579 9.47416 14.2028 -15.1686 39.1263 4.59508 +353 2 12.91 8.74193 13.8564 21.0065 -34.4741 -21.4004 +354 2 12.311 9.21984 15.1046 -5.21536 -3.05923 17.073 +355 1 4.05954 15.2722 6.9713 -12.2847 -13.6907 9.03639 +356 2 3.52733 16.0267 6.71946 -3.69787 8.1984 -1.38185 +357 2 4.94462 15.4979 6.70957 17.3953 3.39893 0.124931 +358 1 0.676716 8.64845 15.0435 0.0448789 -8.8726 2.29819 +359 2 0.388517 9.55355 15.1457 -0.102902 11.258 0.0552156 +360 2 1.38121 8.67263 14.3922 3.78483 -0.0353447 -4.44966 +361 1 12.9131 8.29224 10.2146 2.07907 -10.3878 2.68575 +362 2 13.6346 7.78925 9.80195 -2.79275 5.95566 3.91371 +363 2 12.8029 7.87463 11.0885 3.60602 9.09063 -7.955 +364 1 15.3505 7.77425 3.51602 -25.105 2.18251 -0.815364 +365 2 14.4666 7.51634 3.2857 -7.66712 2.41401 -31.383 +366 2 15.2516 7.5997 4.43625 29.5189 -3.75051 28.1293 +367 1 17.2908 6.71242 0.0288264 8.4359 -0.0595562 3.38218 +368 2 16.7481 6.02838 0.414195 -4.41494 -10.5616 1.77026 +369 2 16.6696 7.39667 18.4317 -9.71571 9.06541 -4.14994 +370 1 8.93558 6.94317 7.77066 11.3734 11.9101 1.30985 +371 2 9.8513 7.28708 7.82315 -13.5624 -4.9569 -0.419932 +372 2 8.83457 6.3282 8.49913 -0.351333 -9.82053 6.39411 +373 1 12.3886 0.605922 1.26733 4.3474 1.63423 -5.64369 +374 2 13.3496 0.62067 1.39833 -3.50709 5.26207 -1.10414 +375 2 12.2365 0.554465 0.317002 3.44844 -5.08055 2.164 +376 1 5.6093 15.1332 14.5298 5.50237 -6.63524 -3.85361 +377 2 4.67729 15.3131 14.6547 -7.5977 -3.56809 4.17708 +378 2 5.99198 15.9265 14.1501 5.33744 7.17763 0.920224 +379 1 3.83862 6.42399 1.72255 -0.530245 0.761181 6.81888 +380 2 3.42185 7.23588 1.41886 -3.5948 7.2146 -3.68667 +381 2 3.94102 6.55655 2.67261 0.00170673 0.796504 -2.59346 +382 1 3.90756 11.5263 12.3817 0.20855 -7.47029 -8.65749 +383 2 4.79535 11.8927 12.4625 -0.681042 -1.53834 0.918823 +384 2 3.33577 12.1179 12.8713 -4.93373 1.57702 0.731635 +385 1 5.31593 3.88159 15.8542 -0.71358 -42.6288 -12.177 +386 2 5.97198 3.22378 15.5406 -6.31298 7.40988 7.32158 +387 2 5.73536 4.71214 15.7787 14.3185 32.9857 -0.935745 +388 1 14.2562 10.2258 4.56557 -18.8652 24.4894 6.04548 +389 2 14.4389 9.92543 5.45169 -1.13053 -5.88778 11.8213 +390 2 14.6954 9.63367 3.98806 17.1426 -20.2086 -20.2139 +391 1 7.6892 17.381 9.10447 19.4711 -25.2283 0.682627 +392 2 6.86971 17.6207 9.51632 -14.1206 10.5396 4.24559 +393 2 7.90224 17.9622 8.37374 -3.5427 12.2774 -4.18627 +394 1 4.51373 14.5018 3.89084 0.522587 -13.0056 -37.966 +395 2 4.5996 15.4052 4.14706 0.258928 20.2029 10.6105 +396 2 4.49773 13.963 4.65868 1.58881 -14.8294 26.2191 +397 1 14.2556 7.39762 15.8429 -9.24001 -8.17606 -10.1746 +398 2 15.1854 7.31956 15.6389 10.3704 -1.38951 -4.38862 +399 2 14.2355 7.83779 16.6857 -0.295639 4.56275 12.5602 +400 1 3.05453 18.3862 1.94671 -28.337 -27.777 -22.0693 +401 2 2.58101 17.7651 1.32015 15.7039 17.8808 20.6311 +402 2 2.35293 0.259745 2.36363 3.01847 1.93426 2.5363 +403 1 7.98344 1.63895 4.58298 -1.95289 -5.65456 5.83277 +404 2 7.39472 2.00993 3.91227 5.60846 -0.877805 -3.34347 +405 2 8.83104 1.39808 4.18815 -5.23209 5.3786 -4.6966 +406 1 2.44155 14.16 17.683 19.8901 20.6744 -11.1998 +407 2 1.71949 13.6284 17.9614 -19.7639 -16.6874 11.6615 +408 2 3.22651 13.6749 17.9404 10.3416 -4.56611 4.09925 +409 1 0.874431 1.8172 13.9017 -2.66591 2.98819 0.0720706 +410 2 0.796895 1.67216 14.8604 0.805718 -0.9226 -9.7327 +411 2 18.6311 1.96655 13.5402 2.6832 0.103556 9.2189 +412 1 4.40474 18.7103 13.8903 -4.51489 2.73844 -3.11833 +413 2 5.26066 18.332 13.6843 10.2731 -0.629088 3.90858 +414 2 4.27285 18.5624 14.8326 -2.10334 -1.04281 2.89108 +415 1 7.22541 0.768378 18.3802 -7.41292 5.22253 -10.0414 +416 2 7.14919 0.357851 17.5011 6.06274 3.8916 10.097 +417 2 6.39657 1.25171 18.5223 1.70256 -10.1891 2.75464 +418 1 16.0038 18.3833 13.9769 4.60778 -2.90009 -16.1733 +419 2 15.0678 18.3553 13.7682 -2.12799 2.80836 4.60244 +420 2 16.1189 18.6995 14.8699 -6.8859 -1.5785 15.9997 +421 1 10.1619 4.59436 16.2508 34.7775 -10.6887 1.26028 +422 2 11.1678 4.58362 16.2281 -36.3206 4.79489 -1.20103 +423 2 9.8959 3.67942 16.0718 3.3051 4.94693 0.644026 +424 1 15.9268 17.7185 4.48585 -0.443376 -19.9814 -7.77196 +425 2 16.5546 -0.221465 4.56619 12.2284 16.6263 -2.03126 +426 2 15.0862 18.0786 4.73637 -15.899 7.019 6.15678 +427 1 6.9987 17.4508 13.864 -28.5259 -4.03497 -9.84039 +428 2 7.52153 17.7102 14.6061 10.1765 7.77338 18.9538 +429 2 7.63162 17.2858 13.1766 11.9873 -1.11294 -13.1093 +430 1 13.256 6.47431 6.57718 13.0919 -2.27803 2.33044 +431 2 14.2181 6.68617 6.52776 -23.2683 -1.75779 -6.09518 +432 2 12.9031 6.34478 5.6793 8.47748 2.51219 6.97161 +433 1 7.82324 2.30197 9.35649 6.58131 4.23212 14.3466 +434 2 7.32826 2.17284 10.185 -1.16662 2.6949 -8.43976 +435 2 7.24342 2.0875 8.62812 -8.03625 -5.88123 -5.84644 +436 1 15.1686 14.8419 13.6961 6.6084 -8.9126 -6.67367 +437 2 14.8499 15.0658 14.5674 -3.29174 5.55862 10.3748 +438 2 14.9102 15.5355 13.091 -7.311 3.85237 -1.87114 +439 1 9.39203 8.3247 3.79765 -11.0731 4.19637 -5.3616 +440 2 10.2213 8.76913 3.95172 10.5135 8.75123 3.89829 +441 2 9.56922 7.39926 3.9554 -1.92777 -9.54221 1.11885 +442 1 17.7628 13.6056 16.4368 0.454101 -14.0132 9.10192 +443 2 16.8123 13.4442 16.4542 -1.43638 -1.23592 -2.30674 +444 2 17.8812 14.4042 15.9249 -1.89469 7.90276 -3.85648 +445 1 4.90818 10.546 2.83916 0.136377 -2.73925 -10.4847 +446 2 5.60998 10.1288 3.34488 4.96678 -0.616571 0.115447 +447 2 4.51664 11.1769 3.44738 0.912314 1.46625 2.09919 +448 1 3.71104 8.38719 10.068 0.753133 0.0228827 -3.76935 +449 2 3.89927 9.29887 9.80067 -2.70003 -3.09285 3.15772 +450 2 3.67512 8.396 11.0298 -2.24059 1.87779 0.37074 +451 1 15.9565 6.94095 5.99865 -8.76526 9.77307 4.96327 +452 2 16.7516 7.41234 6.24421 7.68049 3.9133 2.85915 +453 2 16.2393 6.06165 5.75492 3.70751 -7.34759 -2.0072 +454 1 15.1339 7.14501 9.07066 -1.17949 -23.8082 27.0602 +455 2 15.8283 7.58235 9.55517 11.4438 5.0236 10.3868 +456 2 15.1116 7.57875 8.25013 -4.20744 20.1878 -38.3409 +457 1 6.25297 12.9267 12.7452 -4.72449 1.01458 -5.57239 +458 2 6.98991 12.3599 12.9819 6.62509 -1.61272 7.49964 +459 2 6.12032 13.5727 13.4468 2.47956 2.45399 3.39123 +460 1 12.1116 4.51066 13.1059 -15.4407 -10.6836 -10.9314 +461 2 12.4271 4.59486 14.0171 -10.4637 -2.65404 1.19035 +462 2 11.2547 4.00523 13.0473 26.1752 13.1928 8.83048 +463 1 11.3958 8.13336 7.91828 -4.43196 -2.05658 -14.2843 +464 2 11.9753 7.54394 7.4184 3.39578 1.92795 -0.521112 +465 2 11.8257 8.23937 8.76441 1.22007 0.905858 11.3028 +466 1 17.1296 10.8754 7.54699 -15.2323 -0.655909 3.97588 +467 2 17.811 10.2663 7.31344 17.8297 -18.4071 -0.448075 +468 2 16.9935 11.379 6.74844 -4.7697 12.6356 -6.62113 +469 1 5.29547 18.1363 10.9421 18.5805 -0.935137 -5.10578 +470 2 4.88577 17.8485 11.7431 -9.76906 -7.6723 14.1577 +471 2 4.62403 18.0611 10.2783 -13.9129 1.88822 -17.2145 +472 1 7.59234 17.5076 1.75687 4.86523 1.07577 -14.9702 +473 2 8.00304 16.7666 1.28453 -8.52174 0.253094 2.89961 +474 2 7.35564 18.1425 1.05706 3.89665 -2.44167 8.83688 +475 1 1.92302 12.8778 13.5789 2.91886 3.94981 -7.24471 +476 2 1.45818 12.4106 14.2651 -5.47786 -10.2367 6.99308 +477 2 2.33812 13.6191 14.0211 -0.459782 9.91978 4.14062 +478 1 9.50973 6.75636 14.7983 0.267759 -13.8501 3.13598 +479 2 9.76861 5.87974 15.1842 -3.78976 20.025 -16.8859 +480 2 9.67323 6.78366 13.8359 6.07296 -1.5477 12.5306 +481 1 15.3007 4.25662 10.7816 1.6835 6.93604 -0.852744 +482 2 16.2201 3.94716 10.8841 -13.758 11.9338 1.00514 +483 2 15.2044 5.07319 11.3041 5.68258 -12.2185 -1.66994 +484 1 11.2682 6.20917 0.148653 5.11845 2.03204 -0.614283 +485 2 11.4613 5.3156 18.5351 10.8417 -13.6045 -1.35957 +486 2 10.3344 6.26425 -0.02153 -13.2524 10.0913 1.35666 +487 1 -0.0515508 11.3921 15.0043 28.8186 -12.3739 35.7691 +488 2 18.1888 11.7008 14.2289 -27.1505 12.4881 -39.8426 +489 2 -0.144753 12.1488 15.5889 -3.39882 3.34168 7.51926 +490 1 7.01363 9.26741 7.30523 1.11866 9.50703 -8.15996 +491 2 6.64493 8.42979 7.58084 -4.10674 -7.85165 7.60391 +492 2 7.94964 9.11568 7.16987 5.72986 -2.82238 2.51511 +493 1 18.3266 15.3189 12.3109 1.98396 7.8422 -1.62162 +494 2 0.557814 15.686 12.1521 7.34904 -2.57966 -0.481227 +495 2 17.7488 15.821 11.7275 -2.3238 -0.409324 -3.46342 +496 1 16.5074 4.41847 5.29023 -12.2776 2.5176 -39.1335 +497 2 16.8214 4.00292 6.06235 10.453 -12.003 36.2431 +498 2 17.1989 4.29433 4.62557 3.70164 8.40848 3.22117 +499 1 17.7062 3.18115 10.7633 -10.0415 -0.498888 0.968384 +500 2 18.5829 3.451 11.0307 13.8857 -2.29821 0.377097 +501 2 17.7544 2.33603 10.3089 5.51555 -4.87272 -1.50428 +502 1 12.31 -0.0249004 10.0958 7.06597 -29.3992 -7.90418 +503 2 11.4091 0.228435 10.2265 -21.0592 11.9526 6.39906 +504 2 12.8361 0.735194 10.2786 15.1995 22.0824 4.66414 +505 1 10.3672 9.76964 12.4555 1.27225 -3.68083 -7.54967 +506 2 11.1341 9.82258 13.035 0.839453 -0.704743 2.83749 +507 2 10.2702 8.82174 12.2801 -0.554943 5.543 3.04928 +508 1 0.65465 2.77798 7.04528 -2.13863 -3.2199 7.00126 +509 2 0.891211 3.42266 7.72053 -0.0150652 2.55779 -0.825415 +510 2 0.990123 1.95336 7.40694 -1.54003 -2.33595 0.508806 +511 1 0.295674 15.3348 6.84982 -3.22172 27.5014 26.3495 +512 2 0.521244 15.1551 7.76985 -0.748412 3.60522 3.47657 +513 2 0.484365 14.5358 6.4159 11.6769 -37.1534 -21.5269 +514 1 17.0573 6.99129 15.1128 -10.0859 0.519269 -2.81001 +515 2 17.7626 7.64158 14.9811 2.36054 -7.88383 3.70046 +516 2 17.4128 6.20418 15.5441 6.5971 2.49163 -1.29874 +517 1 9.10445 12.4501 8.04005 25.0355 12.8023 20.768 +518 2 9.46092 11.7782 7.45434 -7.91968 -3.65307 -8.74082 +519 2 8.16829 12.5393 7.95206 -19.3694 -6.70788 -7.44718 +520 1 1.22811 1.76814 2.9182 -6.11732 -10.0295 -0.237983 +521 2 0.712195 2.08081 2.16479 2.12402 6.69579 0.750032 +522 2 1.58605 2.52034 3.3947 3.99278 5.86411 -0.360805 +523 1 4.10894 15.0956 9.93451 6.69744 -1.75099 -1.18621 +524 2 3.96901 15.3261 9.00671 4.91376 -1.44666 0.188494 +525 2 5.04659 14.871 10.0423 -6.23862 1.0691 -5.37016 +526 1 7.35274 2.18983 14.6875 -7.358 8.13743 -4.11606 +527 2 7.08638 1.65776 13.9297 0.32385 -1.91134 2.32143 +528 2 7.57979 3.04743 14.3014 5.83731 -4.25907 3.58957 +529 1 18.4915 14.5922 2.16266 -14.7631 20.4811 3.31696 +530 2 0.685462 15.0501 2.31645 0.801171 -7.89169 -2.84158 +531 2 17.8141 15.3012 2.20781 8.07106 -12.7893 -1.48401 +532 1 9.99475 2.73128 12.8993 -0.14498 6.34622 4.34107 +533 2 9.94968 2.10764 12.1674 -2.02697 0.25981 -1.25528 +534 2 9.23805 3.32791 12.8055 1.37719 -5.85529 0.104676 +535 1 2.96937 8.88969 13.0348 8.45161 15.4602 -1.6792 +536 2 3.19044 9.8379 12.866 -0.537566 -21.2484 3.2835 +537 2 3.7799 8.47356 13.3849 -14.589 3.50084 -4.12479 +538 1 3.21 8.56161 3.75492 -0.42537 -8.47878 -37.7314 +539 2 3.66747 9.30861 3.32521 -2.76458 -7.90594 7.43156 +540 2 3.22415 8.6869 4.6856 3.07128 8.62247 25.8231 +541 1 5.62342 7.20688 8.60781 8.60088 8.53717 -11.0276 +542 2 5.53536 6.26871 8.41561 -2.891 -1.4677 7.62716 +543 2 4.92494 7.48858 9.21156 2.86443 -6.54236 0.635755 +544 1 14.9008 1.47426 1.89198 -2.54888 27.9205 4.61998 +545 2 14.5535 2.29499 2.28075 -2.57285 -15.9361 9.92214 +546 2 15.4844 1.8547 1.23467 3.18874 -15.0862 -12.382 +547 1 8.48736 15.1158 0.783841 -1.15568 2.93173 4.22404 +548 2 9.1238 15.1934 1.5071 4.62293 -5.62872 -5.40551 +549 2 7.79285 14.5509 1.14844 -2.73481 2.50701 -2.31707 +550 1 15.539 1.37952 7.19688 19.4515 3.6409 9.83231 +551 2 14.9389 0.78101 6.7773 -13.8468 -10.3512 -10.8641 +552 2 15.0003 2.07296 7.57775 -6.55979 11.3773 -1.03994 +553 1 5.01034 12.9912 18.4705 -11.9235 -4.12885 0.570622 +554 2 5.4698 12.9987 0.669061 0.312037 0.832023 7.43214 +555 2 5.59011 13.4721 17.8825 4.88062 -0.262691 -5.03625 +556 1 15.3764 8.57785 18.0866 -6.62354 -11.676 10.0569 +557 2 15.6805 9.14973 17.3909 9.52323 10.3388 -11.2321 +558 2 15.2475 9.1488 0.206008 -1.03261 3.33477 1.75561 +559 1 12.066 3.08414 18.3349 -10.3405 10.2428 -1.58162 +560 2 12.3601 2.47993 0.38654 4.70786 -1.39849 -7.75748 +561 2 12.2507 2.72995 17.4495 4.61736 -8.1861 15.8047 +562 1 13.1968 12.6883 5.15757 -0.336282 2.96846 2.60586 +563 2 13.7743 11.9999 4.79412 -5.71366 -0.326721 6.52296 +564 2 13.1697 12.5812 6.12031 6.45904 1.498 -4.43193 +565 1 6.0986 7.21596 0.138974 -12.0498 11.3036 0.237585 +566 2 5.91833 8.16028 -0.0709607 9.65884 -21.2748 10.0237 +567 2 5.34258 6.95155 0.690129 5.85049 -3.44248 -7.26534 +568 1 17.7044 15.8891 14.9714 -7.43083 8.66678 -26.2685 +569 2 16.7907 16.1885 14.8618 6.06094 -1.91119 12.6189 +570 2 17.95 15.7638 14.036 5.46338 -3.82161 12.7361 +571 1 13.1509 0.939295 16.6327 -8.19033 8.72571 -1.54201 +572 2 14.0859 0.833936 16.7968 10.9207 -0.957234 5.29932 +573 2 12.8431 0.0418051 16.5014 -5.83506 -5.32332 -1.35137 +574 1 10.9522 14.5534 7.35938 -9.11436 -19.3925 22.6665 +575 2 10.1531 14.2304 7.85485 20.6615 9.00594 -18.4516 +576 2 11.6365 13.8859 7.56325 -5.91964 10.2955 -7.71128 +577 1 17.5919 8.49388 2.10024 -0.0322199 -9.95032 2.76416 +578 2 16.7206 8.43914 2.53345 10.0393 -1.69965 -6.58888 +579 2 17.6862 7.68098 1.5623 -5.40062 15.1321 4.16518 +580 1 12.403 7.83298 1.98454 10.1699 2.43182 8.97059 +581 2 11.823 8.58837 2.10452 -0.914469 2.41145 -5.63632 +582 2 12.0432 7.27751 1.28772 -5.41827 0.0907324 -1.12401 +583 1 12.0169 14.6214 10.4613 22.6496 -4.80377 11.9203 +584 2 12.2953 14.2566 9.62296 -0.627137 -3.48742 -6.53871 +585 2 11.0904 14.7922 10.4232 -26.4922 1.86569 -7.97999 +586 1 6.79945 6.92747 15.5042 -19.94 -13.6896 0.562857 +587 2 7.71181 6.85747 15.2524 19.187 5.43316 -2.40109 +588 2 6.75196 7.52139 16.2502 2.78602 4.81827 4.32857 +589 1 8.02489 4.54706 13.3799 -9.17747 17.7449 0.879178 +590 2 7.13549 4.71954 13.0119 14.9133 -0.721221 -4.30494 +591 2 8.45659 5.41872 13.4818 -10.582 -17.269 -1.29002 +592 1 13.3893 12.1928 14.3557 -6.07818 9.44403 7.21842 +593 2 12.9754 11.3343 14.2402 3.84433 -8.34325 -3.30791 +594 2 13.789 12.4346 13.5154 0.839467 -1.50598 -4.68274 +595 1 14.6037 9.51924 7.26293 11.3016 8.32374 8.02904 +596 2 15.4883 9.92697 7.3747 -13.533 -2.89904 3.77438 +597 2 14.03 9.85877 7.96896 6.22863 -2.20078 -8.30261 +598 1 12.724 16.8794 3.24165 4.36843 -29.0517 -11.6906 +599 2 12.9143 17.2056 4.10583 4.58985 8.72699 22.0136 +600 2 12.2764 17.5776 2.79705 -13.1015 20.2627 -13.4405 +601 1 1.027 7.08618 17.3856 17.8688 -9.35062 9.83545 +602 2 0.150845 7.20834 17.7372 -11.0357 -5.72224 6.2597 +603 2 1.04228 7.56687 16.5674 -0.430665 10.2682 -15.3686 +604 1 12.9047 4.96423 15.6783 -31.9319 9.90183 -0.420667 +605 2 13.6101 4.38571 15.8945 27.3027 -16.194 0.870052 +606 2 13.2534 5.85423 15.7473 6.89498 8.57473 1.28829 +607 1 2.36359 3.37095 5.13131 13.5367 -21.0772 -51.8355 +608 2 1.78827 3.18983 5.83511 -26.0337 -9.2034 36.1161 +609 2 2.76982 4.19309 5.31063 16.9607 33.0577 11.3338 +610 1 8.25673 11.0457 13.6214 -29.0742 18.4766 -42.051 +611 2 8.3505 10.9269 14.5387 12.3752 -9.07103 37.7912 +612 2 9.04494 10.7715 13.1556 11.3248 -9.59576 5.23465 +613 1 12.933 1.51857 13.2538 -7.42773 -10.5209 16.1392 +614 2 13.555 1.47666 12.536 9.8649 3.44918 -12.9241 +615 2 12.6435 2.43109 13.2999 -2.22529 4.34734 -4.74481 +616 1 6.5593 13.6321 2.14465 -6.91915 6.53865 -12.6846 +617 2 5.89828 13.9136 2.78341 -2.94652 3.12599 2.20918 +618 2 7.14809 13.061 2.63026 6.2374 -5.23981 3.14213 +619 1 15.8933 6.50668 12.6624 16.2584 4.45316 -6.00807 +620 2 16.3963 7.03445 12.007 -8.38894 -8.88658 12.5353 +621 2 16.4415 6.50555 13.4748 -12.028 3.27562 -10.9527 +622 1 16.7983 0.717045 9.56947 3.68169 11.9749 4.12436 +623 2 16.6133 18.4601 9.81273 2.15246 -18.3954 6.85595 +624 2 16.3759 0.833391 8.71872 -3.66349 3.7587 -11.8412 +625 1 6.14397 11.6556 8.30338 8.0817 56.4015 -2.32443 +626 2 5.40727 11.3941 8.82366 -25.1595 -10.6153 12.4164 +627 2 6.54205 10.8782 7.99323 17.2725 -41.4748 -11.5815 +628 1 2.81032 8.69956 0.356218 24.742 -6.25 8.21391 +629 2 2.27105 8.19016 18.4013 -14.5977 -1.17978 -6.66412 +630 2 2.29881 9.42159 0.72289 -11.078 1.63045 0.198871 +631 1 10.1064 10.4292 6.59515 -4.60438 -3.93729 0.830471 +632 2 10.5227 9.70923 7.07758 4.69601 -3.0134 2.20114 +633 2 10.434 10.3774 5.69507 4.10481 0.747976 -4.90006 +634 1 6.80466 15.7541 6.67201 6.06476 3.31695 -2.74514 +635 2 7.12474 16.199 7.46137 -2.48244 -3.95514 6.52968 +636 2 7.21004 16.2686 5.96286 -5.79252 -2.21211 -4.39766 +637 1 6.45958 12.986 5.74076 6.97467 7.4921 0.177054 +638 2 6.67553 13.8767 6.05203 0.11849 -2.56514 -0.0944634 +639 2 6.15828 12.5051 6.51647 -3.32664 -1.56183 1.61673 +640 1 16.774 12.5213 9.71798 -12.6143 2.89661 19.2402 +641 2 17.0082 11.8947 9.03708 5.67192 -3.35034 -8.73073 +642 2 17.3962 13.2453 9.69208 4.02202 2.48097 -6.52464 +643 1 6.17384 2.92225 2.79448 3.9775 16.0199 -22.3947 +644 2 6.54801 3.78326 2.49667 -7.94175 -14.5768 11.9424 +645 2 5.69703 2.59738 2.01124 2.48224 -4.95439 10.1002 +646 1 10.7977 3.13994 3.23713 3.9771 -4.26255 2.57443 +647 2 10.0782 3.73781 3.45741 -0.0760182 2.97522 -1.01161 +648 2 10.5069 2.61778 2.47973 -3.48459 4.35709 1.40724 +ITEM: TIMESTEP +70 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.80152 6.81783 17.9876 -13.1435 8.65537 6.0931 +2 2 7.93927 7.0215 18.3978 9.39494 -6.73756 -6.11522 +3 2 8.64173 6.15327 17.319 -1.79792 -4.8767 -3.2487 +4 1 0.159104 8.33212 6.75565 -1.75886 1.86255 -0.283403 +5 2 0.400553 7.98898 5.87058 -1.56937 3.6046 13.6337 +6 2 0.532733 7.75931 7.44677 0.588181 -1.3305 -10.9259 +7 1 8.56014 0.2064 6.86713 15.1827 -2.1442 1.30375 +8 2 9.48839 0.201881 6.58247 -8.47619 -0.963055 4.35965 +9 2 8.1657 0.891093 6.32874 -5.18544 5.82437 -2.7504 +10 1 6.48158 1.74839 11.7303 -5.73112 -6.99234 -4.49671 +11 2 5.77966 2.25139 12.1582 1.03612 1.63173 -0.79005 +12 2 6.04661 0.9684 11.3341 5.10627 10.6526 7.94811 +13 1 6.96595 5.58057 2.38836 1.68885 13.6464 8.05547 +14 2 6.50498 5.94206 3.17078 2.94101 -7.34901 -12.8293 +15 2 6.93975 6.29059 1.72807 -1.07971 -9.74986 0.444847 +16 1 16.2371 10.2379 16.1019 -30.9876 -7.62323 7.88585 +17 2 17.0175 10.5802 15.7054 20.7335 11.057 -7.58035 +18 2 15.6477 10.9912 16.2983 15.508 -10.4523 -2.02188 +19 1 10.7008 14.9379 2.28795 4.31472 -8.51672 3.50984 +20 2 10.6635 14.2367 2.95607 -1.08681 7.31624 0.965 +21 2 11.2207 15.6296 2.69467 3.48557 9.19098 3.66151 +22 1 17.1795 8.23023 10.7992 8.53416 -1.59534 -8.67541 +23 2 16.5643 8.83199 11.2261 -1.39923 4.26423 7.56567 +24 2 17.9421 8.77596 10.5426 -4.34729 -3.75626 -0.741474 +25 1 14.6688 15.978 16.4285 2.33326 -11.9168 -2.20454 +26 2 13.7825 16.2968 16.2522 -6.84331 1.16869 1.85073 +27 2 14.5784 15.3806 17.1932 6.40998 12.5602 -6.81985 +28 1 12.1084 13.347 0.550082 18.7888 -12.4001 5.31554 +29 2 11.808 13.4241 18.2861 -6.00468 7.05887 -5.4437 +30 2 11.724 14.0175 1.12482 -9.88619 2.03399 -6.75529 +31 1 9.30709 5.48775 3.90966 3.41698 -5.29876 17.2174 +32 2 8.77877 5.25688 4.68667 5.61339 2.83044 3.00189 +33 2 8.64592 5.55872 3.2299 -8.10772 2.16644 -16.0449 +34 1 1.64595 4.02425 11.592 -10.9656 22.1289 -13.9701 +35 2 1.60629 4.97108 11.8395 -0.824037 -11.4025 -3.90562 +36 2 2.20491 3.59841 12.2231 10.5337 -11.1868 16.6964 +37 1 2.06621 6.87149 8.22737 1.24172 3.77126 1.52806 +38 2 2.50304 7.30143 8.97949 -2.75541 -3.2118 -2.64013 +39 2 1.97282 5.93715 8.45613 -0.171499 4.52155 4.26063 +40 1 5.3374 4.4954 7.902 -9.99384 -2.48662 -4.40208 +41 2 5.3873 3.53885 7.92862 5.32096 -10.0353 0.506932 +42 2 4.78906 4.68538 7.13029 -0.632429 8.18831 0.496784 +43 1 3.33945 2.92164 17.4119 -9.04777 -8.0172 12.2496 +44 2 4.01569 3.37904 16.9228 10.8208 5.2633 -7.4392 +45 2 2.90871 3.59334 17.9575 0.609467 0.189965 -2.29637 +46 1 7.45919 5.40741 6.16401 6.01334 0.147035 -1.33637 +47 2 7.84933 5.9815 6.83711 3.51741 -4.84398 -5.3698 +48 2 7.00259 4.70355 6.63733 -2.11297 5.93299 1.70682 +49 1 9.81228 7.01862 12.0561 -1.06857 0.870105 -3.24483 +50 2 10.2542 6.3375 11.5392 -2.78202 1.90065 -0.0845581 +51 2 9.1292 7.39963 11.4807 2.35361 -4.5728 1.86322 +52 1 13.9947 3.68643 8.08173 -5.65395 18.5094 -17.1015 +53 2 13.7843 4.54079 7.64233 1.50666 -18.9 8.64197 +54 2 14.1479 3.8993 9.00085 4.5059 2.7709 6.99075 +55 1 4.5073 17.1442 3.93435 4.48768 -12.0008 8.39889 +56 2 5.39081 17.5321 3.92633 -2.26089 2.72179 -5.35255 +57 2 4.01543 17.3459 3.13072 5.98217 13.0117 -0.399635 +58 1 16.4079 16.585 10.4121 -12.3499 -1.91652 -12.9082 +59 2 15.5551 16.5364 10.8674 2.44262 -0.34105 -1.56006 +60 2 16.2254 16.2298 9.51738 1.66683 0.349555 15.5208 +61 1 1.97926 4.78245 0.194184 -7.72676 6.8376 3.32149 +62 2 2.28164 5.2243 0.992573 8.53964 -6.59001 3.21257 +63 2 1.76914 5.52567 18.27 -2.63275 2.53007 -9.16672 +64 1 11.4134 13.2491 16.3873 0.68902 5.27402 2.7566 +65 2 10.9787 12.3908 16.4988 0.445492 6.36744 -3.52589 +66 2 11.9797 13.161 15.6117 0.593117 -3.37138 0.847423 +67 1 10.1151 10.9818 16.8138 12.4788 0.931853 3.10073 +68 2 10.558 10.1255 16.7937 -4.12284 -0.882862 -0.541555 +69 2 9.18349 10.8105 16.7424 -13.6774 -3.43657 -1.9902 +70 1 11.7994 17.4667 13.4795 12.7765 -4.5476 -2.07039 +71 2 12.3346 16.8373 12.9682 -4.67996 5.77396 2.18605 +72 2 12.2169 18.3179 13.2967 -7.11407 5.85224 3.16387 +73 1 6.41771 9.40938 12.2612 -1.11473 -8.0868 -15.4525 +74 2 7.03744 9.07449 11.5759 -13.2083 9.2101 17.4474 +75 2 6.9295 9.8935 12.9066 11.874 3.71682 2.38348 +76 1 16.2958 12.8923 2.71536 -7.68956 9.05075 5.11912 +77 2 17.1057 13.405 2.60095 0.726983 -7.0699 -1.53932 +78 2 15.5966 13.5689 2.77432 5.93986 -8.84533 -0.161974 +79 1 0.748159 12.7086 5.88144 -10.9756 -4.32923 1.80334 +80 2 1.126 12.5118 5.01571 -4.75041 4.90571 -2.30818 +81 2 18.4243 12.6438 5.75836 11.281 1.67442 1.09101 +82 1 5.27578 16.4085 18.412 4.21131 -11.5608 4.53747 +83 2 5.56823 15.5611 18.0525 -2.79743 5.31701 -3.02359 +84 2 5.61546 16.4141 0.666595 -0.372752 7.00853 0.303479 +85 1 0.645783 7.7249 4.17395 -22.5174 -18.1833 12.2453 +86 2 0.0406635 8.03244 3.50183 -6.8254 3.26088 -7.40309 +87 2 1.47404 8.07846 3.91568 30.354 9.58108 -9.75695 +88 1 3.15689 8.99663 6.46784 -29.6014 22.5811 -11.1032 +89 2 3.73467 8.6187 7.10087 15.4493 -13.4368 20.8179 +90 2 2.24881 8.95158 6.82736 13.2955 -4.68481 -5.71698 +91 1 7.31562 10.4015 16.2316 3.59442 1.76188 5.73087 +92 2 6.55849 10.6763 15.7162 -1.33577 1.2968 -0.922241 +93 2 7.0153 10.388 17.1537 0.717273 -3.98644 -9.35278 +94 1 11.0545 0.930228 4.99952 5.57476 -3.06583 5.10436 +95 2 11.2493 1.80197 4.63341 -8.70362 -0.159614 -5.22362 +96 2 10.8601 0.352804 4.24475 -0.891787 5.80331 3.4075 +97 1 4.31226 2.88036 13.174 -5.147 13.5187 -3.07305 +98 2 4.38813 3.36721 14.0053 4.89736 -4.04185 -0.502489 +99 2 4.16611 1.96327 13.4122 -1.31506 -9.67947 3.52696 +100 1 8.44169 10.2311 1.79631 7.56357 -11.9838 -1.9735 +101 2 8.31668 10.8926 2.47474 -4.45102 7.488 6.50539 +102 2 8.68604 9.43265 2.286 -2.4935 0.872154 -3.30188 +103 1 10.3613 1.71229 15.5051 2.98347 -4.15867 -5.41234 +104 2 11.2858 1.47948 15.6006 4.17674 0.252173 3.54686 +105 2 10.224 1.77346 14.5485 -4.83776 4.02156 4.39256 +106 1 2.62824 12.9587 7.89058 0.896502 -11.3927 -2.22701 +107 2 3.24219 13.4607 7.34422 -0.123332 4.88452 0.659902 +108 2 1.95928 12.6032 7.2874 1.64097 5.4786 -0.796639 +109 1 3.80872 11.636 4.95037 -11.7682 3.18495 22.2339 +110 2 3.64598 10.9456 5.61445 0.836076 6.10931 -6.44063 +111 2 2.95096 11.8687 4.56439 8.15456 -6.07271 -3.548 +112 1 6.68955 14.4669 16.969 -3.81156 3.78561 -6.36768 +113 2 7.31157 15.1356 17.2607 6.01474 -1.04117 -0.64393 +114 2 6.3928 14.7335 16.0851 0.840242 -1.58899 4.15547 +115 1 14.2051 14.5083 3.2908 -7.03725 6.3674 -0.58292 +116 2 13.7783 15.3639 3.15563 1.95336 -1.87129 -0.261548 +117 2 13.7683 14.1355 4.06228 2.52608 -4.66484 0.961916 +118 1 8.56009 18.0702 16.0712 3.20396 -8.67406 4.91505 +119 2 9.14753 17.3445 16.2475 -6.34669 -24.466 3.58587 +120 2 9.1857 0.126611 16.1642 1.87484 33.3672 -8.78222 +121 1 4.70115 1.72624 4.89274 27.4793 -6.96303 -5.48355 +122 2 3.95894 2.26041 5.13304 -17.2548 11.1403 -0.356707 +123 2 5.27782 2.26423 4.3214 -9.62564 -3.87491 4.20048 +124 1 15.0192 12.5587 16.5123 21.7041 14.8698 31.7439 +125 2 14.5985 12.983 17.2917 0.468388 -8.58398 -21.4185 +126 2 14.4797 12.5149 15.7347 -25.1252 4.80555 -9.98379 +127 1 15.7034 18.4851 16.8595 11.2428 14.4774 5.40242 +128 2 16.3726 18.3616 17.5507 -1.30019 6.81093 -3.04699 +129 2 15.2229 17.666 16.8625 -3.30988 -17.6635 -4.60623 +130 1 1.33118 1.27529 16.6047 -9.4861 0.393225 2.74141 +131 2 2.17004 1.71925 16.7831 -4.45817 3.09534 0.768406 +132 2 0.687638 1.66877 17.2201 8.28198 -2.79213 -3.95818 +133 1 18.1871 4.40384 15.9188 -4.2246 -5.6904 -13.4727 +134 2 18.0103 3.84369 15.1415 2.73285 7.2293 11.0268 +135 2 0.486098 4.58175 15.924 0.765927 0.250404 0.0527718 +136 1 12.1931 17.0307 16.1573 -7.03075 -8.39993 15.6705 +137 2 11.4402 16.4961 16.4862 10.3932 12.5123 -4.95214 +138 2 12.1197 17.0939 15.2076 -10.1529 0.179256 -12.7611 +139 1 16.106 2.59107 18.2096 -1.1157 3.6739 1.58184 +140 2 15.8464 3.51014 18.3379 -6.23469 -2.00336 3.76026 +141 2 15.8431 2.36085 17.3192 0.233798 0.882779 -7.24243 +142 1 6.71273 13.8002 10.1277 -4.97427 -8.24119 9.58999 +143 2 6.56779 13.4217 11.0085 1.93353 6.26249 -2.22943 +144 2 6.54815 13.0587 9.53715 2.49444 0.869035 -6.59786 +145 1 10.1873 18.4315 2.70955 18.3562 4.9239 2.5593 +146 2 10.5434 0.318979 1.97838 -6.6136 -2.73616 6.22508 +147 2 9.38189 18.0459 2.39836 -17.7025 -5.54205 -6.95436 +148 1 3.04496 17.7072 6.14474 -26.0897 -13.5421 -17.7616 +149 2 2.15406 17.5302 5.73662 26.1077 6.8467 16.2169 +150 2 3.64192 17.5514 5.40101 1.03601 7.77362 4.67988 +151 1 12.6273 16.8318 7.93854 -11.3452 0.662957 5.12661 +152 2 11.8845 16.2201 7.89678 1.40738 -6.80959 -10.3945 +153 2 12.3926 17.3902 8.68441 7.00662 7.84172 2.34647 +154 1 14.8855 15.2416 8.18261 -13.4645 13.8861 12.0711 +155 2 14.0556 15.7424 8.32689 13.5062 -6.9847 -4.51651 +156 2 15.2561 15.6092 7.37576 4.4997 -5.95581 -2.20609 +157 1 17.7963 18.2323 0.313468 22.8316 -1.73762 -16.8861 +158 2 18.5551 17.7341 -0.0636659 -20.2187 -0.580139 11.9305 +159 2 18.2144 0.43747 0.484185 -10.4644 5.54896 5.21224 +160 1 0.772309 10.5133 1.37975 -10.1333 -30.1062 6.79594 +161 2 0.0813059 9.81759 1.5081 15.2254 18.695 2.54909 +162 2 0.385285 11.1613 0.797203 -0.976125 9.32481 -5.57513 +163 1 1.78018 12.2676 3.33949 2.15539 9.4235 -7.57379 +164 2 1.54035 11.6193 2.6706 -4.1225 -6.27654 2.3776 +165 2 2.05243 13.0385 2.81809 -2.70385 -1.96831 6.56166 +166 1 0.659925 17.2426 4.96586 -18.1386 9.04401 18.0738 +167 2 0.178596 18.0473 5.21064 6.21229 2.02654 -16.1731 +168 2 0.324647 16.6226 5.62628 12.0605 -8.44774 -8.6881 +169 1 1.10032 0.835558 9.36207 -6.74911 6.08386 15.0138 +170 2 1.34007 0.666464 10.2949 -2.02307 -2.81345 -10.1719 +171 2 0.1714 0.592543 9.31025 -1.22709 -3.40717 -2.54195 +172 1 16.7505 2.35163 13.3289 8.60057 15.8485 -12.5846 +173 2 16.88 2.58008 12.3859 -1.48994 0.98841 16.7513 +174 2 16.5792 1.4154 13.3346 -5.94985 -15.1034 2.43107 +175 1 2.68711 15.9094 12.0537 -2.04437 -0.129745 31.1177 +176 2 3.02052 15.4906 12.8711 -6.40464 9.26827 -14.3072 +177 2 3.17282 15.5129 11.3342 0.535683 -2.02659 -8.3952 +178 1 16.4208 15.6182 6.1352 -21.1289 -3.6799 -9.5135 +179 2 17.2955 15.5836 6.51556 8.3115 3.57969 -3.1518 +180 2 16.3537 16.3493 5.49765 5.76519 -7.13598 7.22522 +181 1 5.79664 5.13529 11.8088 -4.38676 10.3557 2.90642 +182 2 5.60006 6.00552 12.2032 -0.739769 -8.67447 -3.0914 +183 2 5.02307 4.59055 11.9941 4.66701 -2.35447 -0.0408817 +184 1 15.1607 4.87263 0.806669 16.5091 -1.57376 7.82361 +185 2 14.8955 4.71033 1.72542 2.63671 -2.24198 -6.9535 +186 2 14.4069 5.23734 0.370441 -15.2288 7.71764 -6.62645 +187 1 16.3977 16.3968 1.96949 3.68196 12.8197 -24.7966 +188 2 15.8359 16.7471 2.65913 3.23547 3.93446 11.4731 +189 2 16.7724 17.1777 1.4991 -6.44753 -16.1278 10.1249 +190 1 0.213933 4.82135 3.88253 -26.808 7.93653 -12.3623 +191 2 0.234051 5.77519 3.99531 2.75938 5.29795 -1.25016 +192 2 0.961943 4.50047 4.34745 23.7428 -13.1307 13.4767 +193 1 2.96019 15.0595 15.1256 -5.74802 5.98414 7.79678 +194 2 2.74143 14.6748 15.982 5.94976 -7.2483 0.528018 +195 2 2.64636 15.9627 15.2549 -2.4967 2.40481 -11.2251 +196 1 1.11613 14.6445 9.47707 24.3082 -3.71628 -27.1602 +197 2 1.83443 14.0608 9.11052 -24.4018 17.7336 11.9542 +198 2 0.662892 14.1245 10.1216 -3.75634 -10.5151 15.6601 +199 1 13.5123 16.5361 11.5209 14.3415 8.92342 18.194 +200 2 13.0624 17.3115 11.1648 -0.833334 -0.722864 -7.66511 +201 2 12.9752 15.7809 11.2867 -3.03575 -6.70349 -11.2125 +202 1 4.68996 1.46706 0.718872 11.9134 2.33738 12.4928 +203 2 4.09477 2.04355 0.241198 -5.36661 3.4607 -5.79099 +204 2 4.1604 0.969338 1.36347 2.85434 0.638429 -14.0321 +205 1 1.49954 18.563 11.8891 -5.50653 18.8512 6.56283 +206 2 1.44134 0.571379 12.6129 -0.0136494 -9.64138 -5.67935 +207 2 2.21117 17.97 12.1221 3.30859 -8.66659 1.78907 +208 1 11.4402 10.1273 4.0296 -14.1313 -2.26429 -1.73879 +209 2 11.5467 10.5306 3.16018 -4.20959 -0.177974 3.37558 +210 2 12.3237 10.0244 4.36159 16.2917 -0.468181 5.60308 +211 1 8.19952 12.1987 3.67367 7.5254 -0.929385 2.30686 +212 2 9.06593 12.5735 3.89529 -5.56433 -0.233543 6.4332 +213 2 7.60827 12.3201 4.43288 5.90715 0.804339 0.890554 +214 1 14.5695 4.00736 3.30806 -0.853883 -3.91237 -3.28064 +215 2 15.2428 4.12216 3.97778 4.83301 -0.192226 6.11595 +216 2 13.7947 4.43075 3.66998 -10.7695 5.18811 0.448659 +217 1 5.68852 1.65707 7.54168 28.123 23.6896 24.0894 +218 2 4.98915 1.23464 8.0079 -23.0977 -17.1785 12.6492 +219 2 5.54722 1.47278 6.63267 -9.12733 -3.0122 -32.3212 +220 1 17.8871 1.01837 4.84182 2.82015 7.71075 0.411156 +221 2 18.4334 1.54735 4.24341 -1.55475 -9.21419 -1.50179 +222 2 17.685 1.60385 5.57556 -2.0638 -1.04483 2.6292 +223 1 6.8166 9.34907 4.51783 5.09473 -9.82493 1.7662 +224 2 6.68916 9.48214 5.46541 0.845655 -0.0829088 -1.52267 +225 2 7.72677 9.02302 4.42297 -5.47106 2.64724 -1.23342 +226 1 2.52902 14.8001 2.0243 -5.93162 -1.84873 -28.2955 +227 2 3.33024 14.7833 2.53171 11.9325 -2.28831 13.4023 +228 2 2.81062 14.7362 1.08886 -6.14041 -0.158095 16.8135 +229 1 17.2862 12.9192 13.1313 -13.4327 18.0081 -1.69868 +230 2 16.3974 13.2513 13.3936 19.5241 -4.39437 -6.93828 +231 2 17.8009 13.724 12.9107 -8.95295 -13.2998 3.51907 +232 1 14.8818 10.557 1.42323 -17.5015 7.25829 9.68839 +233 2 15.2835 11.3752 1.77244 -3.15433 -10.3089 -2.91904 +234 2 13.933 10.5609 1.67153 21.0133 3.93252 -5.34474 +235 1 5.70173 6.62264 4.58284 3.01718 2.50499 1.71703 +236 2 5.75902 7.56019 4.39794 2.55817 9.91828 -0.0203224 +237 2 6.42399 6.43452 5.20085 -6.85011 -4.70646 -2.52597 +238 1 8.0341 8.36204 10.3892 10.4405 -6.77488 -14.8808 +239 2 8.6296 8.90948 9.85447 -2.74542 2.30932 7.48232 +240 2 7.64772 7.74454 9.75603 -3.95063 2.60786 3.00172 +241 1 13.4272 18.4528 5.67238 9.25795 -5.11499 9.49722 +242 2 12.7163 0.440246 5.56173 -10.019 1.98309 -6.96611 +243 2 13.1619 17.9514 6.45613 2.7128 -4.57063 -2.8 +244 1 -0.0270522 2.62208 0.316378 14.2494 -14.2567 4.73545 +245 2 17.7181 2.78355 18.7164 -19.3625 -8.86024 -5.69671 +246 2 0.361548 3.46719 0.160861 21.2807 17.6319 0.792983 +247 1 12.9304 10.9756 9.73287 -28.9199 -18.5822 3.85047 +248 2 11.9453 10.9259 9.78333 22.7984 8.3459 -7.73181 +249 2 13.1639 10.0723 9.99967 2.00349 4.19966 -2.07729 +250 1 0.632704 12.1509 11.1096 7.92792 10.2243 1.08862 +251 2 18.3238 12.1837 11.2671 1.30826 1.36738 8.17016 +252 2 1.12128 12.4175 11.9061 -11.5401 0.628467 -1.63311 +253 1 5.16172 7.34292 13.3779 5.89076 -0.786387 1.26512 +254 2 5.63913 8.13751 13.0818 -0.253704 -8.62988 -1.18816 +255 2 5.64992 7.00871 14.1461 -2.49218 7.71701 -3.25354 +256 1 1.18315 6.80996 11.9457 -21.1971 9.90527 -11.1777 +257 2 0.396163 7.2181 11.5121 19.4256 -12.5543 10.5539 +258 2 1.74685 7.55572 12.1675 3.51989 2.12142 1.71712 +259 1 15.5171 9.71047 12.3281 2.29457 -6.5479 -4.23973 +260 2 15.3017 10.6102 12.0519 -2.15799 -4.39765 10.01 +261 2 15.6816 9.70968 13.2745 -0.591496 3.33032 -0.321137 +262 1 16.5873 12.6729 5.56721 2.76163 -0.166181 -5.31991 +263 2 16.3773 13.5773 5.84608 0.225425 -0.965456 -7.72797 +264 2 16.4542 12.6253 4.60029 -0.729256 4.09093 10.083 +265 1 6.36605 9.79142 0.024922 -16.0501 18.8211 -0.426432 +266 2 5.53971 10.2677 0.213525 8.17613 -4.10964 1.60097 +267 2 6.98218 10.0336 0.714657 7.30358 2.91784 7.9977 +268 1 12.2857 6.09281 4.02237 -18.7873 -18.2554 10.8389 +269 2 12.2499 6.90248 3.51498 -0.180994 1.77121 -11.4426 +270 2 11.3769 5.71462 3.99073 18.6718 6.8659 -0.0124277 +271 1 0.371339 12.8581 0.116813 -11.2914 -0.881026 -5.3546 +272 2 18.6979 13.4634 0.798717 1.88955 0.580482 0.906428 +273 2 18.4407 13.0157 17.9982 0.051521 1.66817 1.81741 +274 1 3.57562 18.6672 8.63597 16.8652 -4.29809 -8.00937 +275 2 3.39672 18.3023 7.75382 0.438355 1.17547 6.33464 +276 2 2.72388 0.290377 8.97499 -6.05452 1.31479 -1.62581 +277 1 7.38199 17.3678 4.46374 -1.38292 15.3105 6.33947 +278 2 7.69148 18.255 4.75287 -6.89683 -17.7129 -9.79531 +279 2 7.51455 17.3077 3.50947 0.595015 4.11355 1.7546 +280 1 9.26329 17.1448 12.185 -8.64248 6.96454 5.63337 +281 2 9.31183 16.2501 11.845 1.80177 -5.78684 -3.53436 +282 2 9.93599 17.2354 12.8685 5.43729 -1.39148 -3.55242 +283 1 13.2821 13.1028 8.02698 11.8692 -15.3168 6.16039 +284 2 13.4688 12.3189 8.5813 -8.97739 12.1367 -7.14337 +285 2 14.105 13.618 8.04076 -8.38267 2.98351 0.0644509 +286 1 14.8025 2.98142 15.4294 17.4288 1.80056 -2.61073 +287 2 14.201 2.26032 15.2834 -13.2348 -7.60023 -2.35086 +288 2 15.3302 3.01554 14.6169 0.118996 0.402428 5.45631 +289 1 9.92493 15.6251 16.9821 6.00495 -5.53666 -0.13681 +290 2 10.4191 14.8506 16.6821 -3.27256 -3.64184 -5.012 +291 2 9.59076 15.3546 17.8439 -3.58917 5.2502 2.724 +292 1 11.2797 8.49868 16.6198 -1.73472 -6.52809 -3.79184 +293 2 10.75 7.88393 16.0952 -2.42874 5.03231 0.808132 +294 2 11.4092 8.05007 17.4587 2.82097 -1.86681 0.519814 +295 1 4.04678 18.2455 16.7988 -8.77416 25.1666 -6.65304 +296 2 4.65779 17.694 17.284 2.06605 -2.99109 10.2548 +297 2 3.96053 0.454509 17.276 5.60906 -19.8799 -5.16878 +298 1 2.27095 4.25175 8.91936 5.9784 -6.58712 9.82608 +299 2 3.2186 4.2524 8.72216 -4.79336 -1.38402 1.94738 +300 2 2.18112 3.96584 9.85003 1.09756 8.39619 -11.3917 +301 1 9.88624 10.3936 9.78011 6.22166 -2.86793 -13.7384 +302 2 9.62293 11.2772 9.51568 -5.75811 3.67729 -6.27375 +303 2 10.0642 10.4241 10.7104 0.548842 -0.969577 22.0405 +304 1 9.71663 0.937962 10.8586 -0.709221 -7.70358 -11.4846 +305 2 9.30987 0.134657 11.1937 5.18354 -4.14977 6.17978 +306 2 9.11908 1.1943 10.1452 4.37988 8.3302 1.85952 +307 1 9.18198 15.0956 10.1953 -4.26962 6.22766 7.58802 +308 2 8.89777 15.9846 9.95951 0.743088 2.4445 -7.53567 +309 2 8.34997 14.6032 10.2066 5.52748 -3.88041 -1.79992 +310 1 0.872205 9.70338 10.2435 26.5305 -15.7209 -40.6294 +311 2 0.885793 10.5746 10.6186 -2.04601 10.7115 5.01116 +312 2 1.5471 9.74995 9.50099 -28.1395 -6.59839 33.8889 +313 1 17.1072 4.85649 8.10795 10.9462 -15.5033 5.93553 +314 2 16.3968 5.45295 8.31142 -11.4282 10.1371 2.96807 +315 2 17.1775 4.27052 8.87929 1.82351 6.10377 -11.9311 +316 1 14.794 14.6968 0.0807509 -15.0506 -16.2211 -7.1198 +317 2 15.1293 15.3316 0.707575 7.57499 5.98458 11.2724 +318 2 13.942 14.3729 0.412504 5.92115 1.12787 4.02247 +319 1 3.8058 11.0463 9.54758 -4.72716 5.89465 -11.0149 +320 2 3.75265 11.4758 10.4012 1.08641 -1.46789 11.7249 +321 2 3.34125 11.6425 8.94232 1.4747 0.62014 0.836248 +322 1 11.3036 10.7395 1.51518 17.421 7.70001 -9.9965 +323 2 11.5572 11.5513 1.04939 0.916953 -2.49636 4.28379 +324 2 10.3663 10.6689 1.38091 -17.6315 -2.91035 -1.9437 +325 1 13.1498 7.19173 12.6392 -12.6781 -12.1868 5.62798 +326 2 14.0645 6.9093 12.7169 6.63809 2.55694 -2.55252 +327 2 12.6264 6.38473 12.8035 6.43409 8.48166 -2.8301 +328 1 9.6244 1.91603 0.948782 1.73007 4.87205 -17.2591 +329 2 8.78103 1.84907 0.47922 2.387 -4.26061 4.8929 +330 2 10.2561 2.20979 0.275304 -2.56753 1.91417 5.98087 +331 1 10.6541 13.4625 4.53479 -4.64228 5.78216 2.02785 +332 2 11.5543 13.1406 4.67483 -3.60366 -2.8444 3.58336 +333 2 10.4931 14.1115 5.23949 3.28752 -7.90473 -1.94244 +334 1 14.4847 1.66582 10.9548 -5.6847 9.24739 -2.41061 +335 2 15.2495 1.25185 10.5509 3.51804 0.734089 -1.48015 +336 2 14.6665 2.62215 10.9157 -2.44239 -9.64589 2.94827 +337 1 14.5153 12.0551 11.6598 -8.57838 4.331 1.02894 +338 2 15.2406 12.4341 11.1775 15.6624 8.75252 -5.54666 +339 2 13.8905 11.8145 10.9694 -5.00706 -1.53612 2.9308 +340 1 8.18805 5.09916 9.82303 -13.8101 6.02591 4.86356 +341 2 7.31243 5.14562 10.2589 14.5937 -0.354252 -5.27398 +342 2 8.2462 4.20505 9.47267 -0.0530366 -3.80538 1.315 +343 1 1.47125 16.9173 18.4665 17.3664 16.657 -21.1079 +344 2 1.9236 17.2269 17.6455 -9.65792 -6.20403 18.6505 +345 2 1.59593 15.9726 18.4726 0.464255 -9.97504 -1.82966 +346 1 1.48039 17.3287 15.3228 1.51401 14.0556 6.72393 +347 2 1.34693 18.2292 15.6575 8.56134 -5.76509 -0.66881 +348 2 0.596093 16.984 15.2507 -11.2139 -7.77617 -1.25224 +349 1 3.58273 5.77174 6.05172 -7.98503 -18.1926 7.56457 +350 2 3.04578 6.35459 6.60151 3.24577 3.33226 -0.333817 +351 2 4.18271 6.30655 5.53303 2.15541 4.89174 -3.71227 +352 1 12.4965 9.48476 14.2165 -0.670713 16.0192 -6.73881 +353 2 12.9556 8.76438 13.7775 2.07937 -6.9932 3.10842 +354 2 12.3436 9.22115 15.1264 1.05397 -7.72063 3.19376 +355 1 4.0654 15.2599 7.01126 14.536 -9.99762 3.77636 +356 2 3.57418 16.0458 6.77165 -4.77502 7.81332 -2.1228 +357 2 5.00035 15.4681 6.83264 -6.89866 -1.23873 3.67355 +358 1 0.723833 8.69198 15.0851 1.39297 0.947643 -5.33928 +359 2 0.438801 9.60781 15.1421 -2.06214 4.43911 1.45744 +360 2 1.38458 8.70272 14.3802 0.858615 -3.42768 2.38717 +361 1 12.8756 8.29184 10.1606 18.5084 -5.85873 3.08502 +362 2 13.7209 7.89345 9.85142 -16.8549 4.13316 8.30657 +363 2 12.7515 7.97965 11.0724 6.23426 1.04322 -7.42686 +364 1 15.3229 7.8277 3.50947 17.5558 22.7432 -34.5468 +365 2 14.4697 7.71438 3.07339 -7.31906 -8.87793 15.8657 +366 2 15.4806 7.65388 4.43399 -18.8005 -15.0751 11.2523 +367 1 17.2596 6.73529 0.0260639 -2.34928 8.60384 0.474092 +368 2 16.7705 6.01921 0.434638 -6.55856 -4.92879 -0.567585 +369 2 16.5991 7.41683 18.4475 3.41319 -8.53114 -0.808778 +370 1 8.95463 6.95692 7.78734 -12.7059 -4.64784 9.91199 +371 2 9.87027 7.23168 7.81087 8.51327 4.71948 -0.0600656 +372 2 8.83651 6.35153 8.53608 0.68522 0.961995 -1.89804 +373 1 12.4059 0.607414 1.26231 3.62116 2.02707 -9.0712 +374 2 13.2571 1.01103 1.48145 3.02509 -6.80244 -1.55076 +375 2 12.4394 0.42011 0.312768 1.30302 -0.072107 7.45087 +376 1 5.61221 15.1181 14.5069 21.81 1.56396 -5.03583 +377 2 4.69671 15.2613 14.7447 -7.9418 2.21424 1.99916 +378 2 6.02853 15.9808 14.3125 -8.14435 -8.16553 0.0834836 +379 1 3.81616 6.42663 1.71897 -4.74342 3.6354 -4.79161 +380 2 3.34042 7.16969 1.31421 3.65203 2.80462 3.7212 +381 2 3.89499 6.64183 2.65143 -2.11765 2.44111 2.19083 +382 1 3.90516 11.4598 12.3793 9.45586 -8.94044 -12.3546 +383 2 4.79548 11.8227 12.4942 -7.15738 -0.735807 -0.876075 +384 2 3.31554 12.0782 12.7961 -9.4854 7.67777 7.65311 +385 1 5.30665 3.87758 15.8091 -6.5654 14.2288 -0.0449474 +386 2 5.99806 3.22942 15.6938 11.0923 -7.17561 -6.6845 +387 2 5.74209 4.7421 15.8325 -0.91092 -4.98763 -0.535492 +388 1 14.1952 10.2038 4.61463 -6.5923 1.74463 -22.8561 +389 2 14.2343 9.86507 5.49824 4.23866 -7.49318 19.2708 +390 2 14.5963 9.53108 4.04607 2.17028 4.66107 2.75401 +391 1 7.63145 17.3499 9.0679 -5.43123 5.71002 -0.0698024 +392 2 6.89643 17.6949 9.58041 -2.21022 -5.88459 7.45639 +393 2 7.83827 18.0718 8.46746 8.40651 -1.69566 -7.5742 +394 1 4.52514 14.4769 3.85867 5.05038 7.53463 5.39007 +395 2 4.64261 15.388 4.18066 -3.91408 -9.29834 -6.31781 +396 2 4.46355 13.9264 4.6465 1.7827 -2.93555 -2.6265 +397 1 14.2493 7.38723 15.8586 4.87219 -5.15553 -0.709446 +398 2 15.1473 7.29965 15.5014 -5.21416 1.68161 3.76194 +399 2 14.3665 7.7773 16.7353 0.544226 -0.39761 -4.2243 +400 1 3.0581 18.4144 1.95119 -22.1859 -8.41359 7.65322 +401 2 2.57832 17.7386 1.43356 3.30075 12.2585 2.4632 +402 2 2.38613 0.281938 2.45339 8.18993 -10.3808 -10.0068 +403 1 7.97435 1.63455 4.58282 23.9975 -9.20271 -17.826 +404 2 7.40194 1.94347 3.87976 -9.32013 4.13397 -1.27928 +405 2 8.80392 1.4125 4.10448 -12.4762 5.5818 15.8983 +406 1 2.4378 14.1623 17.6894 -3.94912 5.20331 -2.53114 +407 2 1.6661 13.615 17.8755 3.58117 1.8004 4.78536 +408 2 3.18519 13.6404 17.9779 13.28 -5.73443 1.82606 +409 1 0.901685 1.86492 13.8925 12.6905 0.691236 2.76957 +410 2 0.97461 1.67681 14.8348 2.02403 -0.73996 0.457614 +411 2 -0.0244921 1.99897 13.7259 -14.1961 2.08272 -4.4518 +412 1 4.37872 0.0904002 13.8777 13.1739 1.11326 -7.50903 +413 2 5.30332 18.4699 13.7308 -6.52685 1.52196 1.48666 +414 2 4.22979 18.5754 14.8098 -5.10379 -2.3914 9.04502 +415 1 7.27651 0.845893 18.3957 -16.6762 17.2151 26.568 +416 2 7.1678 0.492927 17.521 -0.448362 -6.22938 -12.6047 +417 2 6.39207 1.1517 18.718 17.8505 -10.612 -11.3067 +418 1 15.9607 18.375 13.9642 -35.6371 5.35013 -16.5011 +419 2 15.0008 18.4642 13.7578 26.2499 -2.51915 -0.30366 +420 2 16.0214 0.00880953 14.871 6.50934 -2.46523 19.0717 +421 1 10.2176 4.60873 16.2514 5.45645 -16.296 -9.2455 +422 2 11.1834 4.4434 16.3559 -20.4013 6.80033 -5.0518 +423 2 9.84346 3.80184 15.8357 11.7075 10.859 12.3241 +424 1 15.9288 17.6854 4.49702 -25.8895 1.84686 -2.2825 +425 2 16.5611 18.3979 4.49336 8.57016 10.0602 -1.14853 +426 2 15.0697 18.092 4.72548 12.7214 -6.58434 0.45321 +427 1 6.97646 17.4765 13.8835 1.51347 6.32825 6.74987 +428 2 7.46829 17.7625 14.676 -2.92413 -3.08896 -9.25103 +429 2 7.63479 17.4162 13.1781 -0.793447 -1.23312 2.0982 +430 1 13.2369 6.46193 6.55272 7.97686 -7.07829 -14.9633 +431 2 14.2045 6.47863 6.50403 -7.11621 7.88379 2.07663 +432 2 12.9571 6.40302 5.61769 -2.27464 -2.27743 14.9713 +433 1 7.84752 2.28013 9.41028 -8.73892 -0.731414 -17.5278 +434 2 7.29261 2.26329 10.1936 -2.39479 -1.12016 7.77392 +435 2 7.27021 1.99883 8.67538 7.42107 2.89864 6.55304 +436 1 15.163 14.8378 13.7075 -5.08255 6.9114 -1.94911 +437 2 14.828 14.9803 14.5966 0.517852 0.790599 5.03408 +438 2 14.8205 15.5736 13.1818 1.46712 -6.90646 -0.613497 +439 1 9.40195 8.33905 3.81803 -16.6236 -1.1153 -3.723 +440 2 10.1861 8.88666 3.81624 11.7714 1.21262 5.85608 +441 2 9.65895 7.42947 4.01423 -0.646232 2.08147 -2.76231 +442 1 17.7496 13.6056 16.4496 1.61536 7.2683 -6.30775 +443 2 16.7925 13.5164 16.4445 -3.33508 -5.74033 1.31806 +444 2 17.9176 14.3949 15.9026 -1.24178 -7.25826 8.29135 +445 1 4.89231 10.51 2.8606 23.2586 -26.6571 -20.5821 +446 2 5.63741 10.0083 3.24852 -7.78968 12.4235 -4.83768 +447 2 4.54582 11.03 3.56787 -4.03679 11.8248 12.8852 +448 1 3.69823 8.4002 10.0127 -3.60192 -11.2793 13.5005 +449 2 3.83759 9.3113 9.76164 0.279778 8.83932 -1.11316 +450 2 3.64192 8.42085 10.9836 -1.53751 -1.28356 -9.75822 +451 1 15.9467 6.92332 5.94112 11.8737 -8.24502 3.37919 +452 2 16.7476 7.39494 6.19571 -0.497479 1.69122 3.51528 +453 2 16.2467 6.02535 5.70675 -5.68891 13.7396 -0.851978 +454 1 15.1658 7.18492 9.0507 -10.4703 -15.8706 0.47552 +455 2 15.9236 7.59272 9.46168 11.862 8.93317 3.67812 +456 2 14.9906 7.60382 8.20629 4.02444 8.70872 -4.23998 +457 1 6.21618 12.8841 12.7284 -3.21766 12.2709 11.5322 +458 2 6.77909 12.207 13.0973 14.7659 -5.65099 1.01901 +459 2 6.15827 13.5741 13.4151 -3.2657 -3.93324 -9.28774 +460 1 12.1165 4.51288 13.1048 -1.62418 -0.0716723 20.7898 +461 2 12.3817 4.58382 14.0419 2.18295 3.85449 -11.1604 +462 2 11.2475 4.10019 13.1569 -0.321339 -3.45694 -9.73345 +463 1 11.4166 8.11249 7.92599 8.37678 -3.86112 -10.8327 +464 2 12.0468 7.60844 7.37796 -5.38848 4.21425 7.2331 +465 2 11.8428 8.18692 8.79136 -5.59584 -0.0130509 -4.24997 +466 1 17.091 10.8655 7.57222 -5.5019 -10.6926 10.9756 +467 2 17.8562 10.3128 7.37833 -2.02493 -0.998523 -7.2616 +468 2 16.8515 11.3839 6.80089 6.08197 4.8342 -8.48749 +469 1 5.2937 18.1227 10.8823 3.58086 -4.72457 -4.80722 +470 2 4.89277 17.7527 11.67 -2.28546 -3.10604 1.32943 +471 2 4.67512 17.9479 10.167 -5.31481 4.288 -3.34371 +472 1 7.59808 17.4966 1.71058 0.398559 1.64094 13.9409 +473 2 7.8828 16.705 1.25288 5.11743 -4.18927 -7.63945 +474 2 7.62118 18.2252 1.08608 -3.03358 1.0728 -8.8916 +475 1 1.91712 12.8862 13.5909 8.98798 9.32187 -3.03347 +476 2 1.48166 12.3531 14.2581 -2.09819 -2.06604 3.51643 +477 2 2.30811 13.6552 14.041 -7.16378 -5.11315 -1.13098 +478 1 9.42828 6.75322 14.7826 20.1915 -11.5504 -11.1057 +479 2 9.8277 5.94835 15.1588 -6.88663 6.02054 3.69259 +480 2 9.80073 6.79406 13.8821 -8.1098 8.28496 9.35183 +481 1 15.2968 4.25709 10.7854 2.83104 8.23395 -4.89519 +482 2 16.2313 4.08269 10.6128 -5.94582 -2.20316 7.08238 +483 2 15.3124 5.02999 11.3646 -3.5924 -3.42311 1.83328 +484 1 11.2927 6.22318 0.123361 12.5475 12.622 0.859144 +485 2 11.5233 5.29113 18.7512 -7.74436 -5.44097 -5.24926 +486 2 10.3808 6.34995 18.4806 -0.327163 -9.85792 5.03233 +487 1 18.5472 11.423 14.9732 18.3726 -20.3084 16.0571 +488 2 18.105 11.7915 14.2257 -13.2839 12.4126 -20.1368 +489 2 18.4564 12.0929 15.6514 -4.79118 8.10765 5.85542 +490 1 7.00881 9.27577 7.32015 -11.3868 -9.38104 -0.512081 +491 2 6.68278 8.41602 7.64312 1.53223 10.0212 -0.264373 +492 2 7.94615 9.16913 7.19167 13.4366 -2.83724 0.374421 +493 1 18.3388 15.3149 12.278 7.79295 4.11927 0.907342 +494 2 0.562248 15.7272 12.1255 -3.32497 -4.13752 -3.12696 +495 2 17.7171 15.7348 11.6722 2.18188 4.14775 -1.5511 +496 1 16.4968 4.40066 5.28798 -9.94208 -5.06851 -0.773295 +497 2 16.7853 4.2225 6.18546 2.9967 -3.39819 7.99443 +498 2 17.2662 4.33461 4.72457 15.1936 4.75592 -3.34352 +499 1 17.7173 3.18772 10.7866 10.4448 7.42964 -1.18609 +500 2 18.6422 3.37989 10.9855 -1.52891 3.674 4.44234 +501 2 17.7488 2.39891 10.2588 -4.04978 -15.6839 -7.32077 +502 1 12.3149 18.6145 10.0881 -2.22129 4.11252 3.54852 +503 2 11.4444 0.333084 10.2939 -3.02626 -1.86973 1.00626 +504 2 12.9201 0.705852 10.2372 4.71846 0.03299 -1.96706 +505 1 10.3684 9.76179 12.4758 17.9734 4.74974 2.50525 +506 2 11.1916 9.84607 12.9926 -11.8304 0.187235 -1.96375 +507 2 10.3012 8.81681 12.3218 -3.77483 -3.01576 0.0814472 +508 1 0.689392 2.74058 7.08104 -5.98449 10.1616 9.8561 +509 2 0.88859 3.44563 7.72485 0.581102 -9.26818 -8.93017 +510 2 0.974446 1.93578 7.5088 2.3916 -6.77547 7.05728 +511 1 0.277472 15.3259 6.84135 0.228059 -1.31559 -11.5462 +512 2 0.516029 15.5821 7.71821 6.50181 -1.47438 23.8891 +513 2 0.58839 14.4222 6.74639 0.679055 -1.95969 -5.2972 +514 1 17.0529 6.97528 15.0633 10.9144 -7.53558 1.72506 +515 2 17.8201 7.55974 14.9678 -6.11827 1.26888 -1.51964 +516 2 17.4266 6.16431 15.4413 -5.39729 2.11926 -0.659196 +517 1 9.11957 12.4732 8.03484 -32.1356 7.88594 4.6652 +518 2 9.41535 11.8783 7.35952 15.5672 -13.5118 -9.19924 +519 2 8.15954 12.512 7.86156 14.5216 4.72308 9.92056 +520 1 1.18275 1.7303 2.88012 3.13258 6.74516 -6.07855 +521 2 0.990874 2.23802 2.08159 -8.2151 -5.8717 0.0306137 +522 2 1.74436 2.31191 3.39299 4.34337 2.29394 9.11202 +523 1 4.11863 15.0886 9.98721 11.0177 -1.77256 -13.134 +524 2 4.02022 15.2012 9.03136 -3.58336 0.815549 3.23991 +525 2 5.04995 14.8741 10.1041 0.462863 -2.8957 0.615957 +526 1 7.38268 2.21023 14.7219 2.37064 11.9314 4.06902 +527 2 7.04717 1.62795 14.04 0.302375 -0.796384 -5.36483 +528 2 7.78873 2.97247 14.2654 -8.69617 -12.215 6.09363 +529 1 18.4343 14.5687 2.16054 8.35658 -0.618946 0.782777 +530 2 0.682906 14.919 2.34098 -12.2336 -1.59186 -0.620803 +531 2 17.7977 15.2902 2.22089 3.32879 4.73949 -0.959115 +532 1 10.0087 2.72001 12.9057 2.08485 -1.52945 -12.9938 +533 2 10.0412 2.17732 12.096 -1.38389 3.39971 12.264 +534 2 9.25575 3.30628 12.7713 -2.15732 -0.406341 3.704 +535 1 2.9831 8.88024 13.0189 0.952466 11.8173 -3.08609 +536 2 3.31938 9.77893 12.8076 -5.04245 -14.2298 4.61688 +537 2 3.71596 8.41411 13.4449 -4.1112 -0.429279 -5.2011 +538 1 3.20203 8.5912 3.76846 -11.4045 -12.6583 26.9753 +539 2 3.76961 9.22975 3.3591 6.50161 14.1888 -13.0281 +540 2 3.15464 8.85629 4.71231 4.40411 -9.17072 -19.7321 +541 1 5.64764 7.22249 8.60582 -2.45044 -0.628932 2.27153 +542 2 5.55364 6.27099 8.49955 3.15339 -1.29251 -2.67256 +543 2 4.90409 7.47651 9.17344 9.24373 2.45699 -1.73114 +544 1 14.907 1.53023 1.85078 -7.37767 -15.1485 8.29721 +545 2 14.668 2.24872 2.45072 11.5035 7.56218 -5.89301 +546 2 15.6059 1.77377 1.2289 -9.91057 9.46649 1.95684 +547 1 8.55561 15.0845 0.759561 -2.78586 4.97755 1.3099 +548 2 9.2232 15.1059 1.46635 -5.75771 -3.12613 -8.68727 +549 2 7.79979 14.5909 1.11068 3.03755 -1.08449 1.22088 +550 1 15.5064 1.39564 7.20176 -2.04619 -6.07348 -4.735 +551 2 14.846 0.870461 6.73047 4.3658 -0.949999 1.00211 +552 2 15.0733 2.23713 7.35024 -3.19526 7.79987 5.63196 +553 1 4.99693 12.9582 18.4618 -8.43591 -3.95032 12.7964 +554 2 5.427 12.9558 0.691187 -3.21166 1.68806 -6.66553 +555 2 5.5701 13.4759 17.8974 6.4766 -1.03013 -3.5001 +556 1 15.3823 8.61159 18.0651 4.42877 2.22092 -6.07372 +557 2 15.8154 9.23321 17.4587 -2.51695 -7.00562 1.90652 +558 2 15.1591 9.14089 0.186524 -1.03798 5.78876 7.10622 +559 1 12.0334 3.10844 18.3299 11.3082 -20.8993 7.10454 +560 2 12.3341 2.61645 0.471712 -7.66483 12.171 -5.21514 +561 2 12.3614 2.54753 17.6085 -4.58122 9.25845 0.807451 +562 1 13.192 12.7001 5.16537 5.21593 -6.7049 -2.26257 +563 2 13.6127 11.9331 4.74049 -3.39065 6.67562 5.25333 +564 2 13.2679 12.5364 6.11315 0.126366 6.17512 0.133491 +565 1 6.11282 7.21918 0.158665 1.88014 -14.5403 11.0752 +566 2 6.12514 8.17662 18.815 -2.86446 -0.617519 -0.818148 +567 2 5.41227 6.95692 0.781338 0.907384 -1.18964 -10.3034 +568 1 17.7111 15.8907 14.9544 -3.82577 1.28333 3.96962 +569 2 16.7386 15.9987 14.9233 18.3395 -0.0507343 -6.61585 +570 2 18.0408 15.7242 14.0577 -12.1828 1.42979 -0.226855 +571 1 13.1366 0.926204 16.6604 -4.9212 9.87611 -1.92759 +572 2 14.096 0.89187 16.7156 4.29984 -5.34206 5.94224 +573 2 12.8563 0.0335376 16.4436 -2.56348 -3.63873 3.02874 +574 1 10.9184 14.5253 7.38829 1.38398 -2.03118 7.00079 +575 2 10.1136 14.2278 7.85844 13.304 -1.52714 -8.95405 +576 2 11.6006 13.8396 7.51991 -9.17062 7.88742 -1.04716 +577 1 17.6363 8.46247 2.12178 -2.04395 4.31685 9.18728 +578 2 16.787 8.41765 2.58806 4.70486 1.56362 -5.63911 +579 2 17.6123 7.75928 1.47082 0.631216 -3.65047 -4.17578 +580 1 12.4375 7.79355 2.00637 -2.34281 23.5579 2.73553 +581 2 11.9501 8.63365 1.95534 8.51098 -6.49732 1.55884 +582 2 12.0343 7.24559 1.33225 -2.11395 -7.52965 -2.88654 +583 1 12.0451 14.5968 10.4885 2.58602 -10.5702 -25.2135 +584 2 12.3016 14.3716 9.56719 -0.183055 2.34539 21.1217 +585 2 11.1058 14.7694 10.4266 -10.5567 0.791778 1.58055 +586 1 6.78603 6.87835 15.4866 -3.36028 4.68136 22.1121 +587 2 7.71026 7.02894 15.2668 2.14313 -2.1467 -3.22881 +588 2 6.63472 7.41247 16.2893 -0.664868 -8.24615 -12.946 +589 1 7.99755 4.5041 13.3499 24.8278 34.1767 5.68201 +590 2 7.17338 4.66838 12.8997 -9.34484 -1.26894 -9.57598 +591 2 8.42297 5.40326 13.4231 -14.2483 -32.2403 1.51042 +592 1 13.3614 12.2059 14.3726 -2.68828 -3.01756 -2.25781 +593 2 13.124 11.2722 14.2967 -0.0467593 -0.437755 2.8377 +594 2 13.7081 12.4264 13.5024 2.10157 3.54991 -1.69903 +595 1 14.5654 9.5448 7.2719 7.4337 1.87458 1.84958 +596 2 15.4192 9.97446 7.42049 -0.421966 -1.69006 0.109976 +597 2 13.9603 9.96019 7.88547 -6.00597 1.06642 2.40823 +598 1 12.7021 16.8399 3.28406 2.1329 2.22559 -4.89416 +599 2 12.9627 17.2776 4.09814 -1.16793 0.633127 5.57798 +600 2 12.5029 17.5595 2.67417 -2.21511 -1.15635 -1.62469 +601 1 1.01088 7.06774 17.3689 20.0897 -7.47151 2.1243 +602 2 0.171968 6.83932 17.7636 -13.4375 4.7826 3.09836 +603 2 0.861358 7.69882 16.662 -3.49993 1.38105 -6.69635 +604 1 12.9265 4.90969 15.692 -1.72339 7.7777 5.20839 +605 2 13.7461 4.44088 15.8455 2.50132 -9.36464 -4.69309 +606 2 13.1831 5.83499 15.7716 0.254864 4.72294 -0.0726576 +607 1 2.3277 3.38915 5.11911 5.08689 -5.27649 -8.37414 +608 2 1.81648 3.03652 5.84872 -5.99705 -1.71944 1.12123 +609 2 2.79757 4.13118 5.49603 6.03185 12.6803 -1.33855 +610 1 8.22299 10.983 13.6596 -2.68868 6.78672 22.55 +611 2 8.37046 10.9349 14.6227 -7.71168 -0.54916 -12.6902 +612 2 9.06889 10.7219 13.2955 2.07822 -5.6604 -8.58071 +613 1 12.9566 1.54883 13.2404 -6.45532 19.0424 -4.61407 +614 2 13.4436 1.59622 12.409 4.66376 -6.5769 4.30334 +615 2 12.5511 2.44176 13.2892 3.97521 -19.3883 2.5587 +616 1 6.59697 13.6382 2.12308 -19.53 14.6785 -2.92569 +617 2 5.9569 13.9305 2.80289 7.92829 -3.31956 -9.9577 +618 2 7.23585 13.1086 2.59101 5.128 -6.56439 5.02766 +619 1 15.8657 6.47234 12.6041 4.99369 -6.06314 4.28807 +620 2 16.4551 6.98041 12.0348 -2.62867 1.80518 0.0955392 +621 2 16.3109 6.45259 13.4696 -4.62358 3.40022 -7.66147 +622 1 16.7868 0.706192 9.5524 8.10763 10.4692 12.0206 +623 2 16.4993 18.5236 9.95191 3.55616 -11.3811 -4.24312 +624 2 16.3059 0.843102 8.73445 -6.13335 -2.9453 -10.1224 +625 1 6.15553 11.6636 8.28166 8.04937 9.43191 -5.2183 +626 2 5.38812 11.3133 8.7152 -15.4132 0.789816 9.90132 +627 2 6.60546 10.8728 7.99206 7.62403 -6.5238 -2.76924 +628 1 2.80481 8.67956 0.357522 -16.6853 -5.97365 -15.2844 +629 2 2.27492 8.26466 18.2845 10.7138 4.85897 15.9492 +630 2 2.22127 9.36062 0.722932 4.52332 -2.29686 2.25001 +631 1 10.1103 10.3863 6.60128 -6.60242 -1.42487 -6.12592 +632 2 10.6136 9.70804 7.05871 2.40377 -4.05953 3.76861 +633 2 10.2954 10.2785 5.66001 4.13032 2.32994 2.59513 +634 1 6.85077 15.7563 6.70738 -11.7521 -4.07497 3.77538 +635 2 6.99262 16.2462 7.53077 3.71638 -1.24183 -4.26209 +636 2 6.92978 16.3894 5.98454 6.68147 0.141382 -0.214337 +637 1 6.48958 12.9529 5.78988 1.80967 -1.32299 -1.48619 +638 2 6.5811 13.8382 6.15183 4.24501 4.33378 1.70513 +639 2 6.11675 12.413 6.49523 0.159424 2.05888 1.44919 +640 1 16.7629 12.5191 9.71336 -1.62109 -11.3708 1.97787 +641 2 17.0324 11.8284 9.09183 -7.38478 2.50021 2.06117 +642 2 17.4395 13.1763 9.61316 3.98731 12.5093 -0.628579 +643 1 6.20997 2.89816 2.77935 -0.0802363 -5.63791 0.773513 +644 2 6.61167 3.74714 2.54082 -9.15989 -2.58724 -3.98308 +645 2 5.63039 2.60429 2.05445 8.60419 4.25286 3.07741 +646 1 10.7636 3.09526 3.23748 -2.12809 -1.19847 1.63085 +647 2 10.0581 3.70038 3.49376 4.9418 2.80865 -0.749542 +648 2 10.4122 2.60071 2.48751 -0.504171 1.44253 0.108713 +ITEM: TIMESTEP +80 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.8014 6.74321 17.9894 -25.71 0.163943 4.88408 +2 2 7.93592 6.85831 18.4426 18.3019 -2.2716 -9.29 +3 2 8.62145 6.12739 17.2721 4.06901 -0.284928 0.869098 +4 1 0.193099 8.36013 6.75275 5.74913 -14.5769 25.1987 +5 2 0.349094 8.05034 5.86501 -0.249861 0.708817 -17.2091 +6 2 0.558161 7.64099 7.32168 -7.5605 18.9357 -7.69302 +7 1 8.61156 0.29086 6.89037 18.8351 -6.84677 1.91716 +8 2 9.54524 0.192133 6.6105 -17.2936 6.40231 3.46958 +9 2 8.24205 0.986486 6.33979 -0.485036 0.67975 -2.4356 +10 1 6.46061 1.74084 11.7563 18.0716 -9.05138 -10.6926 +11 2 5.90902 2.36746 12.1907 -18.8993 15.6687 11.8916 +12 2 5.86943 1.07894 11.3852 -0.461453 -6.159 1.34784 +13 1 6.94761 5.53992 2.37529 -6.07193 26.0011 19.9509 +14 2 6.56484 5.89454 3.23997 6.76459 -12.0871 -41.8379 +15 2 6.81469 6.2225 1.67437 0.333839 -16.9501 17.8189 +16 1 16.2464 10.2212 16.095 -30.9636 -1.96085 19.7441 +17 2 16.8891 10.4896 15.4774 30.9665 9.88757 -18.0257 +18 2 15.7638 11.031 16.3423 6.62567 -11.9253 -3.68232 +19 1 10.7594 14.9468 2.28506 -10.192 -15.3258 -5.27915 +20 2 10.552 14.3194 2.98639 5.50444 -0.296801 2.35986 +21 2 11.1642 15.6696 2.7411 11.3222 17.7739 6.10774 +22 1 17.1862 8.22111 10.8759 16.4539 0.643281 -9.91552 +23 2 16.576 8.81969 11.3105 -3.64966 6.67804 4.28607 +24 2 17.949 8.77387 10.614 -8.44523 -5.92405 1.0378 +25 1 14.6358 16.0024 16.3895 25.5058 -11.0228 4.42293 +26 2 13.7352 16.2786 16.3126 -22.3429 5.97271 0.576342 +27 2 14.7081 15.5263 17.2386 -3.54281 4.69451 -12.0743 +28 1 12.1273 13.3164 0.564829 -0.361627 4.24339 0.0908299 +29 2 11.7754 13.443 18.3303 1.85705 -5.04776 -15.4247 +30 2 11.6653 13.9884 1.07404 2.42612 -1.45379 10.2607 +31 1 9.30563 5.48822 3.87958 6.5447 0.0363683 25.4904 +32 2 8.87806 5.40536 4.77034 1.54217 -0.907852 -25.4465 +33 2 8.62277 5.52424 3.19838 -5.81373 -1.17005 3.72822 +34 1 1.59219 3.96918 11.5778 -9.84269 42.1113 -23.7424 +35 2 1.65598 4.94531 11.7448 -5.32168 -23.4604 1.30407 +36 2 2.08682 3.52502 12.2368 16.8537 -14.859 24.6718 +37 1 2.0876 6.92307 8.18563 -3.73767 -8.57072 -0.0346284 +38 2 2.39381 7.30463 9.00964 5.23298 7.68032 1.6714 +39 2 2.09597 5.97338 8.35948 -3.7573 0.82597 0.238295 +40 1 5.28961 4.49122 7.85762 -5.23337 8.41869 1.15392 +41 2 5.42981 3.54006 7.92701 -4.09922 -6.37036 -7.26013 +42 2 4.64396 4.70759 7.15783 7.0556 -5.183 4.67383 +43 1 3.36027 2.89954 17.3915 -17.4395 12.4687 22.0366 +44 2 4.05476 3.43419 17.006 5.24509 0.828911 -8.29254 +45 2 2.77379 3.5226 17.8911 18.871 -11.3769 -11.5396 +46 1 7.49453 5.42535 6.18785 1.1565 -0.337813 22.5495 +47 2 7.9164 5.96716 6.90215 -9.87324 -14.4944 -23.4171 +48 2 6.89327 4.79051 6.63979 12.0833 17.318 -7.46699 +49 1 9.81909 7.02563 12.0706 7.31099 -1.858 8.99458 +50 2 10.1534 6.27284 11.5881 4.21769 -4.6772 -1.38273 +51 2 9.09614 7.33889 11.5389 -11.6555 6.63577 -10.586 +52 1 13.987 3.72336 8.09074 -16.8343 16.962 -37.2017 +53 2 13.5442 4.52839 7.7245 12.4076 -19.615 9.33911 +54 2 14.2201 3.91921 8.97962 7.00657 7.67382 26.2916 +55 1 4.5104 17.1281 3.91533 10.7578 31.6451 -21.4766 +56 2 5.3439 17.6347 3.91183 -5.56531 -14.4645 11.3324 +57 2 4.01019 17.58 3.20396 0.717673 -14.6313 13.083 +58 1 16.3456 16.5752 10.4878 9.47486 -6.83722 -28.8723 +59 2 15.5139 16.524 10.9378 -17.3385 1.90191 12.1775 +60 2 16.1667 16.1386 9.62748 3.54118 4.50203 14.5107 +61 1 1.9669 4.78352 0.127126 -0.739304 -4.30462 13.1261 +62 2 2.4124 5.1813 0.904759 -4.07407 -0.50297 -16.3737 +63 2 1.70825 5.48663 18.1668 4.40273 7.87995 3.28325 +64 1 11.3312 13.2592 16.4181 -1.15069 -16.7597 -15.9919 +65 2 10.8158 12.4247 16.4648 10.4615 17.429 3.38388 +66 2 11.9137 13.1122 15.6483 -5.75273 4.84583 10.0297 +67 1 10.0951 10.9476 16.7865 12.4257 -21.5163 1.40398 +68 2 10.4762 10.0399 16.7888 -6.98476 25.4172 2.00859 +69 2 9.15392 10.8219 16.7533 -12.5538 0.302602 -1.38706 +70 1 11.8287 17.486 13.4829 -0.118354 -13.6364 7.15806 +71 2 12.4458 16.8683 13.0504 -5.40922 13.24 -3.88075 +72 2 12.1685 18.3769 13.3708 4.2975 6.3924 -3.60834 +73 1 6.40329 9.45666 12.3007 7.59953 -15.5921 -26.3915 +74 2 7.02951 9.14458 11.6116 -13.6176 6.52201 11.0115 +75 2 6.95635 9.88774 12.9378 9.38595 10.7935 13.1394 +76 1 16.3024 12.9052 2.74142 -15.9403 -16.7132 8.77179 +77 2 17.1501 13.3041 2.5727 9.16723 7.57391 -3.15506 +78 2 15.6647 13.6204 2.85813 1.6204 2.22565 -2.39426 +79 1 0.760847 12.751 5.87222 -24.7031 -12.948 -13.3423 +80 2 1.12648 12.6956 4.9713 -1.82207 2.12621 9.26767 +81 2 18.4428 12.5289 5.74368 26.1358 12.2861 6.31515 +82 1 5.29492 16.3822 18.4146 -5.77927 -1.1636 -2.25588 +83 2 5.45161 15.4933 18.0434 4.5004 13.3336 10.181 +84 2 5.72207 16.4863 0.6292 0.349856 -6.54957 -3.00829 +85 1 0.672446 7.71977 4.17015 11.9206 5.83738 -2.65809 +86 2 0.0599114 7.99601 3.47788 2.17241 0.0211014 0.560686 +87 2 1.51354 8.18303 3.96741 -13.409 -12.9126 0.0558484 +88 1 3.18041 9.04016 6.47644 -48.733 9.26031 0.132627 +89 2 3.67612 8.69495 7.19851 13.8171 -10.3779 15.348 +90 2 2.22175 8.86945 6.71565 32.4894 5.10639 -10.1715 +91 1 7.33809 10.425 16.1982 -13.7714 -1.76245 23.4597 +92 2 6.52669 10.798 15.8343 6.52641 -1.5478 0.375626 +93 2 7.11414 10.2397 17.1395 3.58358 2.1532 -21.3577 +94 1 11.0368 0.910412 5.00755 -5.03762 -2.37072 -20.9965 +95 2 11.0166 1.76948 4.5572 3.99116 -0.122414 9.27702 +96 2 10.8085 0.318039 4.26499 2.41704 1.78329 12.9529 +97 1 4.27055 2.90822 13.1584 -5.03414 2.69466 11.7405 +98 2 4.39065 3.48249 13.9384 2.16314 -12.4788 -5.29849 +99 2 4.11656 2.00207 13.4974 4.2297 10.0998 -5.7581 +100 1 8.47529 10.248 1.79037 -0.416679 -17.2671 7.19176 +101 2 8.23967 10.8662 2.49257 2.8179 1.08296 2.51337 +102 2 8.59639 9.37915 2.23271 0.0130336 16.1865 -5.8343 +103 1 10.3383 1.70852 15.4843 -18.7352 2.46602 -2.29408 +104 2 11.1863 1.36274 15.7269 17.9639 -3.17473 -1.31836 +105 2 10.261 1.74525 14.5183 4.02029 2.26456 4.98686 +106 1 2.61381 12.97 7.91629 0.377646 -9.00714 -10.2558 +107 2 3.20736 13.521 7.38885 -1.73045 4.27865 2.80704 +108 2 1.92972 12.6563 7.30106 5.76016 2.06086 0.889789 +109 1 3.8265 11.6489 4.94253 -18.049 0.292651 15.0893 +110 2 3.64515 11.1228 5.74952 0.240622 6.04317 -17.8646 +111 2 3.00147 11.7074 4.41136 14.7829 -0.870145 11.9003 +112 1 6.67003 14.5068 16.9871 0.195301 -8.52391 -8.20479 +113 2 7.30673 15.1853 17.2075 3.81359 1.00594 1.02421 +114 2 6.51415 14.5784 16.0351 -3.74805 4.58221 3.23833 +115 1 14.2005 14.4991 3.2542 12.2104 -4.1759 -13.149 +116 2 13.9664 15.4191 3.35064 -8.52353 7.22912 -0.280994 +117 2 13.8358 14.0368 4.00136 -6.61808 -5.66537 10.7242 +118 1 8.64986 18.0488 16.0994 -35.3958 -9.60596 -0.188096 +119 2 9.08138 17.255 16.4541 14.3634 13.9351 -5.51429 +120 2 9.16615 0.19969 15.9552 18.9441 -0.541676 3.30098 +121 1 4.69447 1.75392 4.88991 25.859 26.3088 -12.7751 +122 2 3.87089 2.24691 4.93296 -3.58784 0.203107 2.94233 +123 2 5.32887 2.35869 4.40805 -22.2668 -23.8988 10.2256 +124 1 15.0337 12.5563 16.5322 -9.42235 19.0778 45.1845 +125 2 14.5415 12.8308 17.3429 25.2588 -5.91919 -13.7907 +126 2 14.3516 12.6025 15.8912 -15.7131 -4.7436 -33.7881 +127 1 15.7107 18.4933 16.8499 14.0119 15.6823 26.0515 +128 2 16.2364 18.5256 17.6977 -11.7154 -4.95338 -28.5838 +129 2 15.2517 17.6535 16.8181 2.70767 -12.4638 1.72062 +130 1 1.36288 1.31672 16.6317 -8.11361 12.6727 12.78 +131 2 2.12452 1.88684 16.8387 -7.41596 -12.3761 -6.73343 +132 2 0.666274 1.64987 17.2352 10.0682 -8.10993 -10.4284 +133 1 18.2119 4.36953 15.9172 -1.70541 -5.24792 -22.7614 +134 2 17.9042 3.81192 15.1707 6.44647 9.66147 16.3107 +135 2 0.476259 4.62247 15.7042 -5.76089 -2.38794 2.9761 +136 1 12.1484 17.0613 16.1489 -25.1744 -26.2572 32.1897 +137 2 11.4087 16.4938 16.5203 28.1495 25.8696 -8.33389 +138 2 11.9925 17.0682 15.2174 -4.06343 5.18838 -23.7308 +139 1 16.1307 2.63053 18.236 -24.4255 7.46546 -12.7341 +140 2 15.654 3.45006 18.4862 10.3096 -12.6534 -4.96798 +141 2 15.8825 2.42572 17.3162 0.942238 5.76458 9.76029 +142 1 6.69125 13.7819 10.0957 6.51523 5.30674 14.72 +143 2 6.68166 13.4115 10.9958 -3.31201 0.605957 -8.104 +144 2 6.74207 13.0463 9.48799 -5.76864 -9.77159 -4.40801 +145 1 10.1909 18.4566 2.69612 24.6552 12.5235 -11.9688 +146 2 10.5208 0.299966 1.90483 -6.63917 -6.88653 20.5003 +147 2 9.33855 18.1401 2.45819 -23.0922 -9.86885 -6.30041 +148 1 3.05041 17.6833 6.1612 -20.7399 0.346779 9.3758 +149 2 2.11766 17.6882 5.81771 32.7543 -5.44367 1.96306 +150 2 3.663 17.6288 5.4193 -6.60477 0.357372 -5.21379 +151 1 12.6301 16.8021 7.91443 2.73044 3.22351 -7.20597 +152 2 11.8394 16.2829 7.68186 3.48899 3.70212 12.2186 +153 2 12.4619 17.4281 8.63963 -10.075 -5.48551 -5.536 +154 1 14.8863 15.2402 8.20999 -23.6436 14.8183 29.3151 +155 2 14.1404 15.8836 8.27066 14.7388 -14.8318 -6.56535 +156 2 15.2763 15.3549 7.35467 9.52302 6.19548 -12.651 +157 1 17.8321 18.2493 0.273835 -34.2521 -9.59248 -4.32979 +158 2 18.5224 17.6645 -0.0392514 10.753 2.02465 3.4369 +159 2 18.2087 0.412934 0.595185 14.0613 13.0178 4.00109 +160 1 0.763956 10.5262 1.39925 -10.0074 -57.9186 33.1602 +161 2 0.0205775 9.86382 1.5781 27.9288 29.6193 -5.5527 +162 2 0.446448 11.1766 0.811593 -14.5912 25.5328 -23.4764 +163 1 1.80037 12.2889 3.30512 5.17734 11.597 19.2466 +164 2 1.46139 11.5987 2.74824 -6.10095 -9.75588 -16.5262 +165 2 2.13675 13.0044 2.75129 -3.9772 -2.70365 -1.85909 +166 1 0.682885 17.2588 4.99366 18.5034 24.5267 -32.7679 +167 2 0.107172 18.0117 5.16246 -8.54671 -5.12892 6.2039 +168 2 0.50047 16.4742 5.48014 -13.5055 -14.6224 21.6265 +169 1 1.0645 0.823506 9.34737 11.8193 5.83131 5.68962 +170 2 1.36557 0.594309 10.2448 -8.52979 0.55273 -0.975829 +171 2 0.153783 0.559257 9.28231 -13.2671 -5.76719 2.40467 +172 1 16.771 2.35127 13.3608 4.58635 29.8799 -13.6101 +173 2 16.8279 2.7166 12.4388 1.57782 -15.3367 24.752 +174 2 16.4858 1.44141 13.3191 -2.28737 -11.3359 -2.05688 +175 1 2.68433 15.9539 12.0479 2.00481 -8.12072 21.99 +176 2 2.97356 15.5639 12.9056 -4.45908 8.74231 -22.8774 +177 2 3.1524 15.4962 11.3314 -4.16555 3.83231 7.28649 +178 1 16.3902 15.5703 6.15458 18.8333 21.1033 -24.533 +179 2 17.3221 15.5371 6.43733 -15.6071 -4.56317 -0.523174 +180 2 16.3697 16.3474 5.53712 -7.15193 -24.3314 15.8574 +181 1 5.78808 5.16844 11.811 1.07675 -5.38543 -7.05048 +182 2 5.68145 6.03537 12.2081 -3.48533 4.06917 4.5041 +183 2 5.0592 4.65006 12.1655 2.16361 -4.54815 -2.94322 +184 1 15.172 4.89144 0.795633 -0.620892 -0.594882 26.39 +185 2 14.9156 4.81116 1.75201 7.19669 -4.64536 -26.7766 +186 2 14.3985 5.20255 0.336699 -8.8444 5.20324 -3.46854 +187 1 16.3986 16.4119 1.90339 15.122 14.6556 -26.5352 +188 2 16.0454 16.7612 2.71133 -6.27107 5.29423 17.303 +189 2 16.8063 17.1873 1.44657 -8.45441 -18.3773 8.08233 +190 1 0.184762 4.82044 3.92309 -20.0167 36.2337 -7.4234 +191 2 0.305381 5.80234 3.92557 1.42835 -23.0136 0.864842 +192 2 1.01251 4.4465 4.18098 17.0496 -9.16948 9.65169 +193 1 2.95853 15.072 15.1235 -0.929158 -18.0667 1.08146 +194 2 2.81752 14.526 15.9315 -1.93517 21.6459 -9.19578 +195 2 2.47159 15.9015 15.2035 -0.281788 -0.150795 8.17547 +196 1 1.08884 14.6409 9.4443 27.3966 -12.5379 -34.1186 +197 2 1.70575 13.947 9.05916 -23.9186 28.888 17.798 +198 2 0.66831 14.2301 10.1769 -7.64803 -12.9163 21.0233 +199 1 13.5173 16.5215 11.5364 0.489599 15.4909 -5.38356 +200 2 13.0836 17.2895 11.1076 8.88627 -7.75363 7.54599 +201 2 13.0704 15.7764 11.1287 -2.36322 -6.26123 2.87696 +202 1 4.73898 1.52078 0.69167 -9.68217 -10.6702 17.6377 +203 2 4.07875 2.00526 0.184075 4.46446 1.98443 -3.98397 +204 2 4.22033 0.928191 1.27988 9.48282 8.28471 -14.387 +205 1 1.52478 18.5784 11.9214 -16.2358 21.4234 -4.1613 +206 2 1.51367 0.493465 12.7143 -0.730917 -3.29007 -5.80239 +207 2 2.22048 17.951 12.0321 13.8924 -17.5303 6.45556 +208 1 11.4148 10.1041 4.08036 9.63761 14.6797 -7.17105 +209 2 11.6092 10.6619 3.28786 -9.14527 -18.7957 16.2306 +210 2 12.2661 9.96891 4.5224 -0.931524 1.73008 -8.63915 +211 1 8.18373 12.2132 3.70486 4.04638 8.18109 41.2935 +212 2 9.0456 12.58 3.98139 -6.62274 -6.35725 -9.04284 +213 2 7.64552 12.2934 4.54 8.66084 -3.68417 -28.5646 +214 1 14.5934 4.00277 3.33714 14.4882 6.32576 -0.110592 +215 2 15.3087 4.27672 3.93937 -11.245 -6.6719 -0.591331 +216 2 13.7777 4.36055 3.68688 -6.37652 3.17854 3.04506 +217 1 5.71814 1.6621 7.57513 -5.5313 -4.02265 40.0153 +218 2 5.00295 1.12677 7.97081 8.59667 7.25176 -1.51046 +219 2 5.48447 1.71188 6.6706 -7.03261 -0.519715 -37.0679 +220 1 17.8819 0.996597 4.84385 3.28334 1.22129 -8.70029 +221 2 18.3735 1.40853 4.10428 -5.78677 -2.02928 14.9184 +222 2 17.7642 1.64161 5.55539 2.20556 -0.0657175 -7.03701 +223 1 6.81886 9.28778 4.52861 6.25722 -6.76526 -10.2791 +224 2 6.61832 9.39383 5.45723 -0.00817066 1.76549 8.49843 +225 2 7.7574 9.04758 4.4954 -4.05712 -0.0763234 -2.03313 +226 1 2.4854 14.759 2.04442 -7.64745 -7.92423 -28.9185 +227 2 3.31932 14.7218 2.51092 7.63377 -1.04104 5.23896 +228 2 2.65881 14.5612 1.09422 1.17207 5.04057 23.1132 +229 1 17.2643 12.9213 13.1026 -19.9619 15.9168 2.25648 +230 2 16.3761 13.2301 13.4207 25.7036 -1.66639 -12.6722 +231 2 17.7779 13.7212 12.8621 -11.3949 -9.92691 5.05246 +232 1 14.8558 10.5579 1.44832 -24.1837 -11.6243 -0.0449549 +233 2 15.2498 11.3496 1.79784 9.85962 12.147 5.79114 +234 2 13.9164 10.5877 1.7065 14.7293 1.68269 -5.02708 +235 1 5.67033 6.62258 4.57309 8.95784 -16.3381 4.76769 +236 2 5.78141 7.53495 4.33529 5.34224 19.3995 0.612293 +237 2 6.44538 6.37316 5.11369 -12.1071 3.69782 0.132968 +238 1 8.08484 8.3464 10.3723 -2.79238 1.81559 10.704 +239 2 8.60215 8.86766 9.74634 -1.18548 0.238269 1.84293 +240 2 7.34937 7.94467 9.9053 0.580319 -4.15939 -10.1337 +241 1 13.4382 18.465 5.66883 -2.12963 -16.204 3.95429 +242 2 12.6402 0.317353 5.43723 -0.0049589 1.74147 2.86213 +243 2 13.1409 17.7635 6.28441 4.99057 13.7489 -2.35078 +244 1 -0.0389125 2.60201 0.358484 20.6019 -11.619 5.06808 +245 2 17.6744 2.57403 18.7483 8.04315 12.368 -1.45646 +246 2 0.347515 3.47455 0.194182 -8.07269 -1.54831 -1.2857 +247 1 12.9609 10.9078 9.72363 -44.1168 29.5082 -8.54535 +248 2 11.9486 10.9818 9.7709 44.2995 -10.8859 -2.13595 +249 2 13.1901 10.0051 9.91101 -8.5598 -18.2315 3.87517 +250 1 0.590645 12.1909 11.1498 11.7969 16.2942 20.6903 +251 2 18.3214 12.2032 11.4307 -13.062 -2.39731 -5.9775 +252 2 1.05781 12.4788 11.9545 1.3761 -3.96073 -11.1532 +253 1 5.19979 7.35251 13.3459 4.96104 -3.5954 0.621761 +254 2 5.77554 8.05147 13.0099 -6.36891 3.58923 -1.12306 +255 2 5.62026 7.07364 14.1664 0.643961 -0.709679 0.08133 +256 1 1.17273 6.78721 11.9743 -37.7935 -22.2758 -19.6174 +257 2 0.361865 7.16229 11.5551 20.1673 -8.51661 10.9701 +258 2 1.7013 7.51605 12.2195 19.7686 31.2325 8.39364 +259 1 15.5313 9.74152 12.3525 -7.42661 26.8763 14.1834 +260 2 15.1354 10.6339 12.1691 17.2848 -32.3992 2.44097 +261 2 15.9001 9.83422 13.2442 -4.7827 -6.0868 -10.0384 +262 1 16.5842 12.6457 5.58229 -7.58554 26.2756 -26.1768 +263 2 16.3849 13.5701 5.8413 5.71516 -14.5282 0.0223018 +264 2 16.4193 12.6729 4.60395 6.10391 -10.0799 23.5706 +265 1 6.38601 9.81704 0.0456579 -23.7849 0.890546 -8.41533 +266 2 5.51671 10.1854 0.278669 9.54818 -0.234306 -0.813632 +267 2 7.00687 10.1562 0.67255 15.5644 7.03716 17.2844 +268 1 12.2684 6.05846 4.00919 -28.2934 -33.3926 21.5663 +269 2 12.263 6.7861 3.41661 0.234348 22.4834 -18.769 +270 2 11.3224 5.76736 4.06199 25.4812 4.82389 -2.50319 +271 1 0.373791 12.8792 0.072054 -11.107 3.80906 -1.77299 +272 2 18.9015 13.5268 0.779758 -5.73011 -3.33995 1.31101 +273 2 18.3694 13.1354 18.0395 6.43374 -1.82904 2.53089 +274 1 3.55692 18.7013 8.65073 14.893 -16.0199 -12.5754 +275 2 3.38339 18.1698 7.85699 7.36237 7.58391 1.53928 +276 2 2.68044 0.23403 8.96368 -11.3363 8.83032 5.06178 +277 1 7.32525 17.3963 4.4514 17.4309 29.7426 -3.23332 +278 2 7.82401 18.2131 4.74166 -23.0386 -26.7058 -8.39786 +279 2 7.43189 17.3694 3.48275 -1.39589 -2.42936 11.5599 +280 1 9.26525 17.1572 12.169 8.13396 -3.40366 20.592 +281 2 9.29678 16.2438 11.8433 -0.925088 7.81756 -3.33389 +282 2 9.96734 17.2329 12.8546 -10.0311 -2.0771 -17.5408 +283 1 13.2786 13.1508 8.01112 -12.5044 -28.1533 13.0431 +284 2 13.4287 12.5256 8.7581 -3.83031 10.1919 -19.0767 +285 2 13.9208 13.8439 8.10408 14.3758 9.62768 2.82629 +286 1 14.7717 2.95063 15.4663 23.0059 6.37496 -12.5686 +287 2 14.1149 2.31 15.1961 -5.56432 -5.96018 -2.11564 +288 2 15.3514 3.08539 14.6861 -8.35989 -8.63193 12.4086 +289 1 9.95789 15.6422 16.9764 -4.46993 0.793564 -8.8018 +290 2 10.2307 14.8148 16.5569 1.31144 -2.42354 4.42353 +291 2 9.44172 15.4 17.7473 1.0906 -3.95706 9.45227 +292 1 11.2531 8.54113 16.6333 5.17657 0.0418295 -8.84929 +293 2 10.6325 8.00272 16.1399 -5.6117 -5.11655 -0.169214 +294 2 11.5912 7.9918 17.3372 0.751532 -6.83429 5.96975 +295 1 4.09617 18.2775 16.8038 -1.75476 28.7193 2.74196 +296 2 4.5979 17.7227 17.3968 3.26159 -10.0112 3.6984 +297 2 4.13851 0.526798 17.2077 -3.53746 -18.1625 -9.44923 +298 1 2.30039 4.26982 8.91686 21.6694 -5.11589 23.5763 +299 2 3.26852 4.19272 8.75344 -21.2665 0.643644 3.82423 +300 2 2.17319 4.0769 9.88449 2.25335 4.47185 -28.5355 +301 1 9.91449 10.4045 9.82138 -1.36818 12.3774 -23.5261 +302 2 9.54718 11.2486 9.48103 5.13969 -13.6804 7.80682 +303 2 9.93694 10.4191 10.7736 0.214264 3.33848 13.7587 +304 1 9.74784 0.927945 10.8307 17.8645 8.52415 0.395599 +305 2 9.30432 0.217271 11.2949 -5.1784 -7.81016 -3.03012 +306 2 9.13824 1.32484 10.1982 -3.45577 -3.9008 2.04599 +307 1 9.17195 15.1281 10.2005 -15.5022 -1.44929 -2.09464 +308 2 8.96814 15.9769 9.77108 -2.08214 -7.76738 2.59404 +309 2 8.35001 14.5895 10.1068 18.2617 13.451 2.66111 +310 1 0.828362 9.74081 10.2167 22.8302 -4.53826 -35.6406 +311 2 0.863435 10.6794 10.4661 0.846835 -12.3508 -3.07098 +312 2 1.42185 9.63122 9.40918 -26.8549 6.26386 38.0517 +313 1 17.1622 4.86379 8.08044 2.41554 -11.1764 16.204 +314 2 16.3163 5.29453 8.26848 4.74994 -0.845127 5.21041 +315 2 17.4172 4.31929 8.8662 -8.72341 14.5987 -22.1578 +316 1 14.8039 14.6747 0.0449816 -17.091 -7.62196 19.0468 +317 2 15.3137 15.169 0.695817 3.50252 1.08273 0.82912 +318 2 14.0068 14.3765 0.533797 12.6241 2.78049 -10.2188 +319 1 3.85026 11.0642 9.5563 -2.44831 7.24975 -16.8488 +320 2 3.90516 11.4403 10.4374 -3.64435 1.57263 7.30128 +321 2 3.45144 11.7342 8.96857 -1.60708 -4.46554 10.9787 +322 1 11.3552 10.7376 1.50363 23.7004 17.8717 -7.90317 +323 2 11.5499 11.5913 1.05012 -4.60225 -16.5984 9.56505 +324 2 10.4091 10.6312 1.49605 -14.4596 -0.264671 -3.06241 +325 1 13.1456 7.20328 12.6021 -24.9249 -2.39855 5.22786 +326 2 14.066 6.96941 12.5913 17.2615 -6.20786 -1.13088 +327 2 12.6433 6.37391 12.7221 9.22616 8.00521 -2.5813 +328 1 9.63635 1.93928 0.908954 12.9918 3.25798 9.3487 +329 2 8.80616 1.72326 0.497356 -10.689 -0.461065 -8.23177 +330 2 10.2384 2.2422 0.224542 -0.105661 1.67982 -4.44056 +331 1 10.6547 13.4406 4.52244 4.65594 3.65244 26.3326 +332 2 11.5391 13.0824 4.73514 -13.2197 2.26822 -8.08889 +333 2 10.4444 13.96 5.32492 0.722291 -5.69425 -12.9779 +334 1 14.5068 1.61853 10.9473 1.56188 14.5139 4.90111 +335 2 15.3059 1.27791 10.528 -0.453964 2.70191 1.23402 +336 2 14.6742 2.57144 11.1203 -1.66622 -13.4066 -10.2612 +337 1 14.4999 12.0198 11.6401 -20.4 4.4823 -10.6844 +338 2 15.1901 12.5044 11.1683 0.00955556 -6.20474 -4.10181 +339 2 13.88 11.6279 10.9736 17.9431 15.8984 14.8698 +340 1 8.17874 5.12415 9.82106 -30.5984 10.5693 18.9492 +341 2 7.28241 5.07355 10.2519 27.6442 5.22023 -11.9731 +342 2 8.30253 4.26697 9.4335 2.62166 -17.6444 -4.58757 +343 1 1.47714 16.9429 18.4887 13.3148 33.7663 -28.6254 +344 2 1.86682 17.2437 17.6257 -9.89818 -8.00998 25.1444 +345 2 1.74527 16.0479 18.574 6.31239 -26.8006 -0.778427 +346 1 1.45374 17.3594 15.3268 42.8952 -1.15706 -0.811193 +347 2 1.42588 18.2136 15.749 -3.30828 11.7666 5.73369 +348 2 0.584657 17.0429 15.2318 -41.4551 -8.54136 -0.705167 +349 1 3.54007 5.76039 6.04888 -8.98595 6.80975 7.90297 +350 2 3.01039 6.43039 6.5207 7.85999 -10.8756 -2.65394 +351 2 4.1622 6.27284 5.52252 1.18276 -3.83664 -2.43702 +352 1 12.5413 9.50789 14.2278 14.1386 -34.2774 -1.94842 +353 2 12.9806 8.74877 13.7665 -10.1246 23.4373 5.48687 +354 2 12.3781 9.12309 15.104 -2.49329 10.5308 -3.54938 +355 1 4.07791 15.2392 7.05947 28.2061 -4.52306 7.60827 +356 2 3.62905 16.0551 6.82 -1.6925 3.55103 -3.37365 +357 2 5.05246 15.4367 7.04645 -25.4492 -3.49557 -3.60676 +358 1 0.767125 8.74429 15.1186 -1.35051 -1.02403 -4.71838 +359 2 0.502685 9.67668 15.1423 2.70563 -3.13172 -3.80763 +360 2 1.44028 8.65803 14.4206 -5.36892 5.64782 6.7911 +361 1 12.8556 8.29114 10.1154 40.5883 -11.1151 11.7349 +362 2 13.7543 7.93714 9.90509 -23.2563 4.30646 -4.77873 +363 2 12.8036 8.10553 11.059 -7.7965 -1.57596 0.639248 +364 1 15.3061 7.91627 3.47282 -42.6646 -27.0181 14.5138 +365 2 14.4087 7.67951 3.19876 7.83283 16.2655 -25.9683 +366 2 15.288 7.37548 4.27198 30.0578 14.5578 6.00353 +367 1 17.2193 6.75387 0.0348868 -24.2654 8.60155 -9.76068 +368 2 16.7331 5.97981 0.339573 3.08011 -1.47023 2.02216 +369 2 16.4984 7.35116 18.3587 20.6605 -10.5931 7.39935 +370 1 8.96527 6.96977 7.82312 -33.6536 -16.7811 13.5927 +371 2 9.86459 7.23854 7.79988 29.8916 7.79708 0.58286 +372 2 8.85329 6.36072 8.58482 2.84704 12.8992 -8.98126 +373 1 12.4369 0.615517 1.24835 5.12967 -8.6669 -10.2958 +374 2 13.1996 1.14046 1.50868 5.63 -3.81589 5.32704 +375 2 12.6841 0.248493 0.387703 -6.12727 4.87774 5.89397 +376 1 5.63437 15.0947 14.482 15.2573 18.1506 -1.5187 +377 2 4.74012 15.1756 14.8216 -5.87791 -1.19647 -0.853033 +378 2 5.96659 16.0211 14.4028 -4.19512 -21.3346 -4.32131 +379 1 3.78146 6.44452 1.71439 -10.0957 17.3086 -10.1533 +380 2 3.36154 7.20469 1.26344 3.84289 -8.07011 2.3383 +381 2 3.80108 6.73559 2.62781 1.97525 -3.80667 6.02801 +382 1 3.89131 11.3886 12.3597 10.4858 -4.45626 -8.95185 +383 2 4.75702 11.7925 12.5217 -6.56671 -1.88331 -0.935479 +384 2 3.25208 11.9718 12.7596 -7.39976 8.19237 6.18945 +385 1 5.30831 3.87649 15.7567 -11.2019 61.1278 12.0088 +386 2 6.01892 3.27998 15.6709 29.6235 -28.0721 -9.85567 +387 2 5.7476 4.76544 15.8793 -15.8563 -28.9516 -7.19779 +388 1 14.1175 10.173 4.66017 9.40425 -19.9217 -33.2768 +389 2 14.1461 9.82294 5.54158 6.86029 -3.38102 17.8715 +390 2 14.6328 9.51646 4.11155 -16.0552 24.3993 16.1239 +391 1 7.5636 17.329 9.02789 1.81886 -5.76611 4.78707 +392 2 6.9813 17.6417 9.74433 4.383 2.36677 -11.0761 +393 2 7.91242 18.0661 8.5041 -5.60089 1.56926 3.7162 +394 1 4.54646 14.4437 3.82391 2.35855 8.70422 24.1238 +395 2 4.58695 15.3758 4.17596 -1.73775 -31.732 -9.36156 +396 2 4.50325 13.8127 4.58585 2.14298 18.0212 -18.4803 +397 1 14.2437 7.3639 15.8726 24.9361 2.31774 6.81444 +398 2 15.0991 7.30759 15.3921 -17.5628 0.546592 9.39404 +399 2 14.5002 7.74932 16.7373 -8.89015 -4.19374 -15.8798 +400 1 3.04207 18.4209 1.96748 -18.4085 17.9201 24.7102 +401 2 2.5353 17.8449 1.40649 -4.22111 -10.717 -13.4847 +402 2 2.35407 0.262093 2.48798 16.8127 -9.3976 -15.4809 +403 1 7.96924 1.62215 4.56344 31.9424 -9.467 0.421552 +404 2 7.35201 1.92948 3.90341 -1.64239 4.88827 -11.6355 +405 2 8.85795 1.52282 4.13815 -26.2226 6.52533 8.08337 +406 1 2.457 14.1626 17.6995 -18.6259 -8.83368 10.0969 +407 2 1.68725 13.6009 17.9701 23.9808 13.2635 -8.93306 +408 2 3.24279 13.6711 17.9492 9.2771 -5.34798 1.51385 +409 1 0.927142 1.91914 13.8849 28.4694 2.81528 -14.4963 +410 2 1.17928 1.66855 14.7668 -1.31862 -2.11333 16.1229 +411 2 -0.00784116 2.01924 13.8762 -26.8609 -0.0423979 -2.90492 +412 1 4.3639 0.116891 13.871 19.5154 5.98388 -10.2249 +413 2 5.3312 18.592 13.8382 -18.25 -1.84578 0.0905254 +414 2 4.09014 18.5553 14.7613 -1.68072 -4.35498 12.29 +415 1 7.32185 0.935992 18.4254 -25.1976 4.88188 40.3736 +416 2 7.29261 0.583526 17.5599 3.22929 -13.7772 -30.1977 +417 2 6.39141 0.906009 18.7671 22.6248 8.40202 -10.9225 +418 1 15.9043 18.3822 13.9598 -30.4853 6.92778 -31.02 +419 2 14.9691 18.5865 13.6701 32.1757 -7.76669 18.1984 +420 2 15.9697 -0.290473 14.9111 -4.96086 4.78357 11.6174 +421 1 10.2566 4.62301 16.2429 -20.4053 -21.3362 -19.7333 +422 2 11.1923 4.47268 16.3843 6.75918 3.74651 0.0845893 +423 2 9.94726 3.80759 15.7722 8.97755 19.5704 18.0095 +424 1 15.9188 17.665 4.49409 -30.8876 16.8748 5.69015 +425 2 16.5463 18.3904 4.38809 -0.624131 1.21894 5.03495 +426 2 15.0755 18.0798 4.84388 28.6139 -15.2662 -13.1828 +427 1 6.9464 17.5119 13.903 30.1459 16.134 14.6047 +428 2 7.45538 17.7973 14.7126 -14.438 -11.5296 -22.8133 +429 2 7.62564 17.4897 13.1926 -14.0494 -3.94126 11.1274 +430 1 13.2241 6.43487 6.53037 -11.3028 -4.49966 -3.41689 +431 2 14.1722 6.56035 6.47079 5.41657 3.67276 -3.81812 +432 2 12.8747 6.35097 5.62176 7.42053 0.356932 11.8509 +433 1 7.85865 2.26615 9.45505 -4.28533 -3.16859 -37.0089 +434 2 7.29966 2.29372 10.2234 -12.0252 -4.85104 14.2867 +435 2 7.31757 1.89726 8.71059 11.6806 10.5906 18.7024 +436 1 15.1499 14.8389 13.7285 -7.78284 7.72319 0.275575 +437 2 14.8617 14.9509 14.6481 -0.524909 3.36892 -5.65775 +438 2 14.6832 15.507 13.1912 6.48748 -10.1003 7.43034 +439 1 9.39784 8.36731 3.82962 2.5344 -9.0015 0.237957 +440 2 10.2136 8.88179 3.87227 -2.41531 -0.25237 0.330419 +441 2 9.66909 7.4454 3.98022 -9.00345 8.8328 -4.59515 +442 1 17.7291 13.5977 16.4646 5.88425 13.7422 -6.32319 +443 2 16.779 13.4368 16.4502 -3.47507 3.66531 -1.64514 +444 2 17.9175 14.4327 15.9665 -10.227 -20.4783 11.0606 +445 1 4.89529 10.4518 2.85531 35.8078 -15.8912 -9.72696 +446 2 5.76001 10.066 3.12945 -20.0856 5.21459 -7.60385 +447 2 4.65599 10.9551 3.62329 -7.19184 9.4675 7.77805 +448 1 3.68184 8.40606 9.96257 -7.06038 -13.6752 25.4145 +449 2 3.73025 9.3314 9.75201 2.05841 13.8137 -4.67922 +450 2 3.5201 8.39907 10.9276 1.35511 -1.83367 -14.7667 +451 1 15.9506 6.91676 5.90036 8.23349 -12.8437 -5.59708 +452 2 16.7283 7.39089 6.23923 -5.44721 -6.23743 -4.31526 +453 2 16.2459 6.04307 5.54881 -4.37327 20.9496 12.2757 +454 1 15.2047 7.21919 9.02648 -8.23364 16.7266 -25.0777 +455 2 16.0013 7.62239 9.37026 6.97324 -0.496136 10.989 +456 2 14.9764 7.76869 8.23928 2.79192 -13.8116 16.1423 +457 1 6.18989 12.8346 12.7303 -2.33267 17.6694 7.57139 +458 2 6.82101 12.228 13.1265 8.54383 1.14333 3.13472 +459 2 6.09938 13.6243 13.3122 2.17121 -15.6415 -7.8487 +460 1 12.1177 4.51675 13.1173 40.066 24.623 8.84127 +461 2 12.3608 4.67527 14.0558 -10.9347 -6.25445 -11.8552 +462 2 11.2865 4.0907 13.0625 -30.7168 -15.659 3.72413 +463 1 11.4382 8.09379 7.90765 11.4031 -1.65515 0.349674 +464 2 12.1555 7.64923 7.40412 -12.1024 3.57709 12.4555 +465 2 11.7306 8.14579 8.84607 -3.22191 -0.660368 -24.1915 +466 1 17.0422 10.838 7.59458 18.8696 -14.9771 -17.3127 +467 2 17.8015 10.2845 7.30277 -16.9558 5.34042 10.7777 +468 2 16.8989 11.446 6.8574 -4.66599 0.747798 1.74373 +469 1 5.2881 18.0926 10.8094 -12.0199 -6.67836 -5.57022 +470 2 4.87565 17.5902 11.533 4.52174 5.42574 -9.9319 +471 2 4.66447 18.0398 10.0548 7.40461 3.40643 11.786 +472 1 7.61349 17.4864 1.6652 -5.64906 3.24499 15.5952 +473 2 7.84327 16.7088 1.17852 12.3306 -20.6776 -4.28559 +474 2 7.74119 18.1865 1.04014 -3.89506 18.5858 -12.7246 +475 1 1.91944 12.8991 13.6003 2.94725 10.7513 13.4495 +476 2 1.49936 12.2949 14.2301 -1.35275 4.24281 -4.32331 +477 2 2.12078 13.7179 14.107 -1.08361 -15.4355 -11.6139 +478 1 9.36899 6.74386 14.7638 -2.26814 18.4847 -3.39127 +479 2 9.81478 6.02606 15.213 8.95117 -11.473 0.808352 +480 2 9.85086 6.98618 13.9577 -2.76657 -9.1339 3.81591 +481 1 15.2853 4.27459 10.7783 -6.29839 -2.79317 -1.65183 +482 2 16.2088 4.11106 10.5808 3.62417 -3.44414 3.50356 +483 2 15.3067 4.91761 11.4912 -1.69264 4.92972 1.1484 +484 1 11.3393 6.23844 0.0959214 -19.2017 -19.0623 -2.27733 +485 2 11.4465 5.27934 18.8311 9.36926 7.99257 -4.22996 +486 2 10.3892 6.29463 18.5179 14.2332 9.643 5.73673 +487 1 18.5128 11.4549 14.9487 -3.47415 -8.47336 -12.1105 +488 2 18.0135 11.8846 14.234 9.23154 -3.06455 1.62932 +489 2 18.3213 12.0172 15.6945 1.79799 8.69016 10.3557 +490 1 7.01602 9.27569 7.3226 -14.4634 -16.8581 15.1781 +491 2 6.67273 8.48369 7.80259 5.98597 16.4947 -15.5019 +492 2 7.96023 9.16216 7.29002 13.6661 -3.40194 -2.89589 +493 1 18.3593 15.3216 12.2421 14.2565 8.37053 -9.09139 +494 2 0.609114 15.6531 12.0121 -9.26774 -5.34503 6.02371 +495 2 17.7657 15.7501 11.6106 -0.96984 1.15192 3.02291 +496 1 16.5123 4.36636 5.2899 -20.1169 0.0802899 32.1896 +497 2 16.6197 4.39367 6.27015 0.689823 -6.50354 -17.1519 +498 2 17.3637 4.55338 4.93619 30.7718 -0.208347 -14.1282 +499 1 17.7452 3.18489 10.789 3.81546 21.3325 5.47337 +500 2 18.6747 3.34524 11.0396 -11.7638 -6.52287 -4.76545 +501 2 17.6832 2.38146 10.2881 5.2294 -17.628 -7.02183 +502 1 12.3161 18.6216 10.0891 7.2643 12.1904 3.38538 +503 2 11.4836 0.405415 10.3905 15.4316 -4.87983 -6.88019 +504 2 13.0526 0.636416 10.1289 -21.6037 -8.70048 2.57237 +505 1 10.3866 9.75789 12.4872 13.2725 15.9888 14.5072 +506 2 11.1625 9.86545 13.086 -15.7493 -4.39745 -10.7974 +507 2 10.2528 8.81785 12.4 2.63286 -10.7197 -2.15993 +508 1 0.710964 2.68685 7.1375 -0.1398 22.218 7.12103 +509 2 0.988905 3.47272 7.66294 -4.49485 -18.6961 -10.7978 +510 2 0.93208 1.94131 7.68754 4.63119 -8.38422 8.20051 +511 1 0.281684 15.3172 6.85959 12.828 -38.7344 -20.2135 +512 2 0.500898 15.7193 7.67574 7.5107 6.97721 30.9172 +513 2 0.662709 14.3998 6.92418 -16.2289 29.7866 -9.89698 +514 1 17.0547 6.94606 15.0133 0.165691 -3.90506 -0.393601 +515 2 17.812 7.5465 14.9118 -2.55694 -6.08978 1.76467 +516 2 17.3809 6.10212 15.3719 1.63232 8.8395 -1.4121 +517 1 9.12112 12.493 8.02809 -41.9273 18.4298 17.1595 +518 2 9.51251 11.917 7.38329 0.012751 -17.4797 -14.5944 +519 2 8.13115 12.5622 7.88239 38.3085 -7.50107 -2.24579 +520 1 1.15265 1.71178 2.84381 -8.4531 -11.9611 -9.59212 +521 2 1.05399 2.26522 2.05124 -0.803687 -1.8039 9.5303 +522 2 1.83355 2.04817 3.41993 6.13064 16.5152 3.77918 +523 1 4.1533 15.0772 10.0179 -3.20174 -0.437736 -9.29092 +524 2 3.98656 15.1016 9.06421 1.0299 1.2944 4.52592 +525 2 5.05261 14.7702 10.1253 7.00528 -3.42074 -2.93025 +526 1 7.40026 2.22746 14.7687 6.49168 5.19513 -3.0061 +527 2 7.05161 1.63346 14.1063 -3.12724 -4.90201 -3.09738 +528 2 7.91685 2.87588 14.258 -12.5256 -3.95349 11.2802 +529 1 18.373 14.546 2.1576 32.8202 -8.56769 3.71586 +530 2 0.641523 14.7991 2.40659 -13.3331 -4.12423 -2.43111 +531 2 17.8688 15.3457 2.17573 -14.9783 16.0191 -2.18472 +532 1 10.0269 2.72027 12.9069 6.62939 -13.0178 -15.3878 +533 2 10.0552 2.15154 12.1041 -3.85604 9.52515 15.5624 +534 2 9.22213 3.24102 12.837 -1.7712 4.41938 -1.42751 +535 1 2.97754 8.87028 12.9985 -9.05038 -0.677068 -3.47801 +536 2 3.45417 9.69118 12.8049 -4.31376 -0.734034 1.18179 +537 2 3.62806 8.2766 13.3769 7.01874 -2.97808 -1.19575 +538 1 3.19567 8.6035 3.77658 -19.8399 -15.185 62.8422 +539 2 3.69787 9.2024 3.27039 20.7823 26.7884 -21.1607 +540 2 3.25417 8.93577 4.73429 1.71088 -18.6185 -45.3432 +541 1 5.68333 7.2353 8.59567 4.24349 7.94903 8.11652 +542 2 5.64033 6.27333 8.54735 -2.49289 0.630165 -0.0839225 +543 2 5.00997 7.53803 9.22801 3.10928 -6.89318 -6.51723 +544 1 14.901 1.57394 1.8387 15.5968 1.99798 -17.643 +545 2 15.036 2.2757 2.46438 -7.07983 8.8607 13.8203 +546 2 15.4483 1.85956 1.08282 -11.9705 -11.4344 6.74504 +547 1 8.60581 15.0641 0.724175 -1.0343 -0.581701 -1.65436 +548 2 9.36267 14.9264 1.3224 -11.0408 7.07619 -5.07103 +549 2 7.85377 14.5885 1.11097 4.42293 -0.805501 -0.698164 +550 1 15.4669 1.42093 7.20398 -6.02567 -16.758 -12.9624 +551 2 14.8047 0.91537 6.67859 11.4397 13.2212 12.6179 +552 2 15.1632 2.33261 7.23494 -7.42764 0.585266 4.6538 +553 1 4.96609 12.9239 18.4605 4.9692 1.49742 18.5571 +554 2 5.35493 12.9668 0.719228 -7.36506 -0.705061 -15.6984 +555 2 5.64055 13.3191 17.899 -0.422768 -0.432726 -0.922633 +556 1 15.3869 8.64959 18.0541 15.2167 5.00615 -15.1922 +557 2 15.9585 9.21901 17.4831 -18.3202 -12.4364 12.18 +558 2 15.1184 9.19177 0.153179 1.36579 6.92031 5.44875 +559 1 12.0051 3.11685 18.332 2.92261 2.37371 -0.430118 +560 2 12.2267 2.91556 0.611981 0.907964 -7.8545 -12.3252 +561 2 12.4512 2.48545 17.7302 -5.34745 5.71129 14.8863 +562 1 13.1901 12.7142 5.17454 1.37013 -5.58194 -4.10925 +563 2 13.4698 11.8626 4.7966 3.05379 7.74077 7.48289 +564 2 13.3871 12.6804 6.11832 -0.290674 -0.040691 0.190289 +565 1 6.14326 7.19304 0.194857 -1.9202 -41.4233 1.79985 +566 2 6.22321 8.10871 19.0299 -3.97355 27.3971 1.06104 +567 2 5.34431 6.86352 0.645447 4.46952 5.26437 -3.48858 +568 1 17.7307 15.8888 14.9367 -21.823 -0.594011 -1.7362 +569 2 16.7484 15.9241 14.9389 21.2696 3.13718 0.352088 +570 2 17.9521 15.7271 14.013 1.78287 0.501162 -2.11552 +571 1 13.1218 0.925759 16.6825 5.50042 -3.78674 2.95198 +572 2 14.072 0.793445 16.8378 -4.97223 1.91263 -2.37602 +573 2 12.7827 0.0340456 16.5234 -2.01103 3.41826 1.69274 +574 1 10.8951 14.5133 7.41586 13.7556 -0.655539 -10.0126 +575 2 10.113 14.0867 7.762 -7.55253 -2.39401 4.078 +576 2 11.587 13.8348 7.46973 -1.14 7.89944 2.21203 +577 1 17.6887 8.43188 2.14728 0.189858 20.0466 16.1607 +578 2 16.8137 8.45099 2.54699 -1.17102 1.13639 1.13697 +579 2 17.5844 7.88298 1.39033 0.906265 -19.3865 -19.2668 +580 1 12.4753 7.78007 2.02858 4.8513 20.3782 0.840615 +581 2 12.1866 8.68618 1.79587 0.511972 -15.0552 5.00442 +582 2 12.026 7.17575 1.43189 -2.95773 1.13832 -8.42618 +583 1 12.0482 14.5597 10.5042 0.0757192 -7.5571 -35.1431 +584 2 12.4064 14.4181 9.58152 -17.4466 3.18024 31.1693 +585 2 11.0871 14.7065 10.4137 10.382 -0.64313 -2.04102 +586 1 6.77399 6.81718 15.4895 -2.25325 13.5751 22.5023 +587 2 7.66157 7.15195 15.2455 -13.2429 -8.30723 6.82645 +588 2 6.46823 7.3192 16.2828 11.602 -10.345 -19.2772 +589 1 7.96932 4.46689 13.3146 44.2968 21.2749 25.8476 +590 2 7.30275 4.56825 12.6635 -24.5307 9.83264 -18.6775 +591 2 8.36434 5.36687 13.4905 -14.8867 -29.3495 -5.61281 +592 1 13.3256 12.2141 14.3822 1.63527 0.767161 7.05401 +593 2 13.3071 11.2456 14.3976 -5.0343 3.13323 -4.4607 +594 2 13.6638 12.4664 13.5147 0.299935 -1.6824 -0.371902 +595 1 14.5332 9.57639 7.29372 1.70864 -17.4355 -8.36329 +596 2 15.3543 10.0193 7.49698 9.6305 7.8311 1.84335 +597 2 13.8455 10.0241 7.76467 -11.6358 9.67674 12.3645 +598 1 12.6873 16.8129 3.32056 7.83014 22.6359 -6.17069 +599 2 12.905 17.3242 4.12577 -3.6908 -4.91509 -14.526 +600 2 12.6713 17.4548 2.56832 -2.22777 -11.4506 21.1383 +601 1 1.00404 7.03926 17.3541 -3.3312 4.1638 -9.33324 +602 2 0.198847 6.6977 17.7452 -7.86562 1.94891 9.68399 +603 2 0.682364 7.69734 16.7196 12.0745 -4.24482 -2.37704 +604 1 12.9524 4.87174 15.7195 8.90342 0.650689 -3.85785 +605 2 13.7851 4.36673 15.5939 -16.3603 12.0475 7.07164 +606 2 13.1756 5.81397 15.8059 7.81047 -7.07308 -0.568692 +607 1 2.31363 3.41121 5.09984 1.34414 -8.27729 12.6429 +608 2 1.77118 2.94066 5.78541 14.4044 18.7697 -14.1923 +609 2 2.78995 4.15649 5.52715 -11.381 -10.4766 -6.15296 +610 1 8.18617 10.9369 13.7076 0.678078 1.53711 40.2692 +611 2 8.26353 10.8511 14.7174 0.0908521 -0.97824 -49.4206 +612 2 8.97116 10.5326 13.3071 -0.268246 2.83437 5.42064 +613 1 12.9797 1.57395 13.2253 -11.1668 13.2146 -3.30054 +614 2 13.4836 1.606 12.3812 -13.0456 2.80048 17.4401 +615 2 12.3844 2.37352 13.292 24.5144 -24.3843 -9.90982 +616 1 6.623 13.6575 2.08401 -19.1133 11.282 9.3836 +617 2 5.9939 13.9784 2.7781 14.9337 -6.87798 -17.2483 +618 2 7.26745 13.1178 2.55198 -2.04458 -0.845032 2.89429 +619 1 15.8406 6.42424 12.5401 -13.2713 -11.8586 11.2716 +620 2 16.4194 6.98592 12.0445 9.49352 10.2235 -13.5209 +621 2 16.1454 6.51524 13.4484 4.14662 -0.822673 1.52229 +622 1 16.7707 0.701968 9.54479 -0.33564 -15.5889 9.3319 +623 2 16.6398 18.4357 9.88026 3.64558 8.61996 -2.27841 +624 2 16.2643 0.755347 8.72872 -0.899564 4.78829 -7.90839 +625 1 6.16924 11.6733 8.25771 14.6298 -10.0406 -3.26225 +626 2 5.33846 11.3866 8.66461 9.26092 -3.17897 1.03444 +627 2 6.69681 10.8652 8.03849 -20.9756 15.4878 5.14008 +628 1 2.79271 8.6573 0.35403 -23.76 -9.02274 -22.2632 +629 2 2.25448 8.23641 18.2541 16.977 17.0562 34.1458 +630 2 2.21462 9.29512 0.821612 5.57875 -9.71134 -10.0126 +631 1 10.106 10.3292 6.60358 -3.61165 1.9136 -10.2284 +632 2 10.6792 9.71276 7.06962 0.244318 -4.43661 2.14915 +633 2 10.3272 10.2595 5.65755 0.987804 2.37269 11.054 +634 1 6.86896 15.7547 6.74185 -9.45188 0.350857 10.5778 +635 2 7.01957 16.2495 7.56813 1.20841 -3.75655 -8.95365 +636 2 6.86937 16.4078 6.03145 5.97827 -1.66506 -1.56051 +637 1 6.52554 12.9289 5.84178 -0.357514 -5.09084 -2.41361 +638 2 6.62829 13.798 6.2286 3.16894 9.75908 1.28602 +639 2 6.09212 12.3914 6.51525 3.69897 1.96572 0.733322 +640 1 16.7568 12.518 9.72465 -9.23185 -13.2632 0.47822 +641 2 16.902 11.7866 9.09243 0.130969 14.0381 8.74694 +642 2 17.3592 13.2171 9.48659 4.61146 3.47499 -3.98224 +643 1 6.24919 2.86496 2.77119 -11.0856 -12.869 -3.38869 +644 2 6.47325 3.75226 2.51474 6.07925 14.4727 -0.649249 +645 2 5.68088 2.55654 2.04869 4.52067 -4.17334 4.94091 +646 1 10.7277 3.04594 3.24275 -5.68944 3.06595 0.875255 +647 2 10.1765 3.79746 3.50451 2.82785 -3.23936 -2.03517 +648 2 10.278 2.63972 2.48897 0.815959 0.513447 0.723514 +ITEM: TIMESTEP +90 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.787 6.66827 17.9842 -16.1402 -3.16192 1.04025 +2 2 7.92621 6.66814 18.4555 15.1954 -0.455805 -12.5376 +3 2 8.71175 6.0436 17.2441 2.25338 3.19171 10.1252 +4 1 0.22099 8.38854 6.75163 1.7867 -5.58088 53.0968 +5 2 0.258391 8.22026 5.83332 5.30707 -13.3892 -38.1472 +6 2 0.61579 7.61263 7.23543 -10.6686 22.8516 -15.6901 +7 1 8.66795 0.370206 6.9239 18.6241 3.37743 -9.56875 +8 2 9.59619 0.315354 6.61478 -16.3273 1.21351 7.23111 +9 2 8.27983 1.03351 6.33448 -2.90229 -5.54848 4.92815 +10 1 6.43573 1.74596 11.7835 34.1799 -16.6044 -13.764 +11 2 5.93979 2.40996 12.1988 -27.1883 29.6469 18.8725 +12 2 5.80753 1.07598 11.5419 -8.40397 -16.9848 -5.34211 +13 1 6.95318 5.50156 2.37044 -56.4905 40.6357 15.9903 +14 2 6.31995 5.85318 3.09808 38.0444 -22.8427 -29.8317 +15 2 6.63738 6.03683 1.59693 20.7004 -19.4106 17.4304 +16 1 16.2563 10.1963 16.0713 -10.5934 -3.27458 3.94447 +17 2 16.9716 10.3961 15.4827 15.3322 4.9096 -4.70747 +18 2 15.8903 11.0434 16.3496 -2.84586 0.096923 -3.72852 +19 1 10.8156 14.9572 2.29652 -13.5477 -14.1276 -10.2117 +20 2 10.6343 14.4303 3.07787 2.79926 -3.05354 4.26547 +21 2 11.1766 15.7627 2.6355 11.3372 16.7492 6.7502 +22 1 17.2002 8.21443 10.9436 15.2126 5.40823 -8.20499 +23 2 16.6458 8.84622 11.4125 -4.33506 2.62691 -0.328418 +24 2 17.9515 8.74734 10.6145 -8.68143 -7.05886 2.54317 +25 1 14.6067 16.0259 16.3377 27.3765 -5.03456 2.51249 +26 2 13.6996 16.2768 16.4047 -22.3019 9.86517 -5.17321 +27 2 14.7963 15.6285 17.196 -1.96556 -8.36093 -2.03831 +28 1 12.1458 13.2907 0.563101 15.519 -14.4585 7.5186 +29 2 11.8598 13.3671 18.2945 -8.9445 7.51312 -6.12139 +30 2 11.6592 13.8773 1.15113 -3.3891 6.78651 -5.827 +31 1 9.32161 5.49231 3.86239 -40.7454 -0.097831 27.7 +32 2 8.82419 5.45502 4.73277 24.2157 -2.28744 -25.4595 +33 2 8.56838 5.45751 3.23664 18.1191 1.43276 -0.568008 +34 1 1.5546 3.92475 11.5547 -2.15894 45.2634 -4.40984 +35 2 1.55046 4.88574 11.8201 -3.55694 -26.3933 -6.97822 +36 2 1.92957 3.45678 12.2837 10.4321 -13.9157 16.7147 +37 1 2.10319 6.96614 8.15085 -9.44208 -8.37285 -17.308 +38 2 2.4095 7.43328 8.92365 8.57391 0.445975 10.2393 +39 2 2.10294 6.01871 8.3456 1.70875 2.69997 7.84786 +40 1 5.23855 4.482 7.82422 -14.5525 -1.69806 -15.7353 +41 2 5.37847 3.52895 7.72628 3.24739 1.15002 6.52498 +42 2 4.55634 4.7134 7.1559 12.5144 1.33119 10.811 +43 1 3.38552 2.88255 17.3879 -7.38377 33.0145 14.859 +44 2 4.08387 3.35622 16.9066 -6.09174 -4.5148 -0.339366 +45 2 2.81217 3.57956 17.8286 22.0641 -22.8641 -14.398 +46 1 7.5324 5.43864 6.19559 -6.90202 6.90038 35.1799 +47 2 8.08818 5.95892 6.84983 -22.5477 -17.4794 -25.4925 +48 2 6.78022 5.04202 6.71812 26.5249 9.35209 -13.645 +49 1 9.82024 7.03039 12.0775 19.8901 0.0780072 21.9724 +50 2 10.117 6.21395 11.6931 4.07542 -9.22938 -4.80372 +51 2 9.09589 7.30435 11.5485 -23.243 9.22364 -20.0663 +52 1 13.9806 3.7694 8.09667 -19.6388 4.31534 -31.7671 +53 2 13.3819 4.49155 7.81719 15.167 -9.87345 1.12215 +54 2 14.3046 4.00637 8.94223 9.52837 8.93591 30.7953 +55 1 4.52742 17.134 3.88467 -0.450754 13.2049 4.39156 +56 2 5.37483 17.5703 4.13521 -18.32 -2.84079 -10.9512 +57 2 3.94957 17.708 3.32475 23.4139 -10.9615 8.41036 +58 1 16.2726 16.5634 10.552 38.1711 -6.17539 -26.5181 +59 2 15.4837 16.6086 11.0514 -31.396 0.528555 16.213 +60 2 16.0986 15.9648 9.80419 -5.24542 6.81385 7.69127 +61 1 1.94125 4.78402 0.0638345 24.0582 25.3647 11.1071 +62 2 2.62474 5.1599 0.67023 -17.1428 -14.5257 -4.57865 +63 2 1.76164 5.54704 18.141 -7.28608 -7.40463 -3.41134 +64 1 11.2518 13.2771 16.4354 2.60185 -12.9515 -12.3757 +65 2 10.6918 12.4717 16.5304 19.7397 14.6013 -5.52798 +66 2 11.8919 13.1107 15.7025 -16.8897 -0.368153 14.685 +67 1 10.0575 10.919 16.7613 6.16873 -18.0385 3.66167 +68 2 10.4442 10.0133 16.8612 -13.1447 30.924 -0.515142 +69 2 9.09987 10.8482 16.7186 0.711039 -4.16381 0.34444 +70 1 11.8614 17.5086 13.5019 6.48767 -7.71286 -13.5562 +71 2 12.4999 17.0938 12.8959 -9.94411 -4.10313 8.27478 +72 2 12.0757 18.4326 13.4127 -0.0140719 16.2542 2.74368 +73 1 6.39981 9.50139 12.337 -4.6648 -8.8035 -19.3883 +74 2 6.97362 9.2422 11.6012 -0.80266 1.15987 5.77958 +75 2 6.9622 9.95325 12.9581 6.38846 6.66359 6.95977 +76 1 16.2975 12.8974 2.78222 -12.345 -27.8929 4.9875 +77 2 17.1496 13.2141 2.51749 15.349 9.48057 -2.38836 +78 2 15.7502 13.672 2.87844 -10.3717 9.81447 0.854078 +79 1 0.774 12.7819 5.86324 -32.223 -2.64552 -12.7856 +80 2 1.10971 12.9185 4.95432 -4.25214 -7.81578 11.8108 +81 2 18.4306 12.6074 5.76822 36.341 8.50215 1.05579 +82 1 5.29891 16.3721 18.4261 6.47 -16.9938 9.7884 +83 2 5.51669 15.4746 18.1046 -4.53971 18.6444 -2.10572 +84 2 5.85038 16.4657 0.570301 -5.83847 6.29943 -2.02707 +85 1 0.695227 7.70772 4.16735 36.5725 18.4792 -22.7587 +86 2 0.10368 7.96447 3.43723 6.76909 -3.37176 10.733 +87 2 1.60166 8.10351 3.91123 -45.3891 -20.8895 14.9183 +88 1 3.19365 9.10151 6.50287 -37.0597 -13.4257 3.63648 +89 2 3.6513 8.68447 7.23829 0.216969 0.250287 -1.31356 +90 2 2.24726 8.75126 6.54108 37.1121 17.8096 0.286984 +91 1 7.35199 10.4473 16.1779 -19.0362 -10.3824 27.97 +92 2 6.56517 10.9544 15.9216 9.49501 -5.7134 5.26362 +93 2 7.13832 10.0279 17.0488 0.309364 15.3336 -19.7914 +94 1 11.0163 0.890853 5.00632 -3.98909 -12.3472 3.8442 +95 2 10.8807 1.76939 4.61668 6.53092 -8.55309 -4.92776 +96 2 10.738 0.225438 4.34173 2.35985 18.608 2.04389 +97 1 4.21667 2.95093 13.149 10.2014 -19.1015 31.4776 +98 2 4.53515 3.41914 13.9504 -8.71013 -4.86526 -13.316 +99 2 4.15898 1.99936 13.4513 -0.534052 25.4454 -15.6313 +100 1 8.50322 10.2612 1.79208 -4.34668 -17.3092 21.2914 +101 2 8.27549 10.8526 2.5321 5.30441 -1.44182 -6.44774 +102 2 8.58493 9.36982 2.21324 2.85947 21.4101 -9.02924 +103 1 10.3161 1.69184 15.4745 -6.1912 0.342966 -7.58309 +104 2 11.1781 1.38278 15.7166 17.9205 -0.758309 5.87707 +105 2 10.347 1.84648 14.5196 -5.50104 2.18071 3.0962 +106 1 2.60936 12.9662 7.92592 -2.1007 2.96569 -8.82009 +107 2 3.10883 13.7131 7.55922 1.74385 -4.33572 0.675454 +108 2 1.96491 12.7329 7.23617 6.25685 -1.04193 4.90183 +109 1 3.83706 11.6816 4.96058 -22.5573 -14.4893 8.95363 +110 2 3.56827 11.1846 5.76493 10.0033 8.11351 -16.9036 +111 2 3.08816 11.5736 4.33469 10.7007 11.5305 11.906 +112 1 6.6582 14.5337 16.9912 3.19916 -10.5164 -7.18554 +113 2 7.36558 15.1576 17.1605 2.12516 -0.469731 1.77687 +114 2 6.47854 14.5937 16.0445 -2.82585 4.49818 1.60201 +115 1 14.2037 14.4903 3.21857 16.956 -7.57282 -16.8086 +116 2 13.9492 15.374 3.44691 -9.21692 15.261 -0.929302 +117 2 13.8764 13.9351 3.91269 -8.69982 -10.6193 13.7942 +118 1 8.69855 18.0357 16.1264 41.5507 -6.08144 10.5978 +119 2 9.33855 17.4056 16.5195 -30.3672 -5.67283 -6.86348 +120 2 9.34419 0.0405339 15.8183 -19.2067 16.0047 -5.03817 +121 1 4.69307 1.79842 4.89677 16.2385 30.5389 -26.6001 +122 2 3.80396 2.19318 4.80489 14.8244 -2.46841 6.40587 +123 2 5.29999 2.32882 4.27745 -28.5893 -25.5208 24.7929 +124 1 15.0277 12.5795 16.5521 32.6678 1.07726 26.51 +125 2 14.723 12.7481 17.4682 -6.07814 3.10734 -21.8061 +126 2 14.3421 12.5499 15.8992 -22.7964 0.862239 -7.92322 +127 1 15.7044 18.5089 16.8468 26.9219 -3.0014 45.6431 +128 2 16.268 18.6119 17.6883 -20.0241 -2.05323 -42.0683 +129 2 15.5234 17.5608 16.7959 -6.5303 3.1055 -1.70461 +130 1 1.37672 1.34924 16.652 -10.0314 2.12664 3.94932 +131 2 2.13238 1.94076 16.8287 -14.5592 -12.7899 -0.0819953 +132 2 0.657997 1.59844 17.2733 17.8805 -0.89879 -9.33461 +133 1 18.2331 4.34642 15.9005 -0.884234 -3.04582 -21.1642 +134 2 17.8346 3.73179 15.2509 9.01129 10.3034 11.7071 +135 2 0.449037 4.61451 15.5361 -9.49368 -5.77709 6.1071 +136 1 12.1007 17.0847 16.1341 -21.8736 -13.8645 50.4236 +137 2 11.3773 16.6353 16.6829 29.7152 15.2039 -30.2146 +138 2 11.8045 17.1565 15.2358 -4.92233 -3.24187 -16.5992 +139 1 16.1203 2.66556 18.245 -33.6191 11.8512 -24.8852 +140 2 15.5683 3.39571 18.6154 19.5646 -10.4389 -9.45588 +141 2 15.8602 2.60471 17.2935 4.4965 0.524143 22.3318 +142 1 6.68711 13.7575 10.0686 6.57394 0.780895 15.4701 +143 2 6.65896 13.3749 10.963 -3.37269 2.77311 -6.77332 +144 2 6.71723 13.0193 9.46247 -3.0919 -8.05072 -6.49535 +145 1 10.1832 18.4638 2.68288 15.4984 11.1175 -14.1442 +146 2 10.4797 0.410785 1.94548 -7.56539 -13.8801 19.3089 +147 2 9.29042 18.2071 2.48382 -12.5464 -2.66261 -5.58966 +148 1 3.06565 17.654 6.19973 -11.4817 2.82915 -15.5316 +149 2 2.17867 17.6912 5.79869 7.15707 -3.68965 15.0105 +150 2 3.60434 17.7569 5.40979 11.429 -4.57556 5.13078 +151 1 12.6359 16.7831 7.87678 -34.4323 5.42099 5.88286 +152 2 11.8215 16.2589 7.70694 19.4452 0.972157 -0.554869 +153 2 12.3283 17.4377 8.53506 12.9634 -4.48143 -6.06952 +154 1 14.8812 15.2555 8.26349 -9.13488 6.23831 13.721 +155 2 14.2179 15.9485 8.09528 6.25869 -7.42326 0.874894 +156 2 15.4123 15.1764 7.46942 0.572987 8.13089 -2.89012 +157 1 17.8363 18.2748 0.235726 -36.9104 2.14965 -2.72595 +158 2 18.5544 17.6878 0.132306 25.4932 -25.6882 -8.95291 +159 2 18.2375 0.371142 0.648791 5.78715 27.9621 12.2792 +160 1 0.76648 10.5228 1.42349 -23.6052 -44.6853 36.9297 +161 2 -0.0625164 10.0248 1.72181 36.7073 15.4552 -13.6362 +162 2 0.483164 11.1861 0.82966 -10.4498 25.872 -24.2739 +163 1 1.81496 12.3027 3.28068 4.06427 7.40541 18.1542 +164 2 1.38036 11.6556 2.74613 -8.62838 -16.0879 -14.4133 +165 2 2.12935 12.9782 2.6808 0.203437 6.54347 -1.70293 +166 1 0.715096 17.2857 4.99328 6.02973 16.9927 -22.851 +167 2 -0.0549074 17.8034 5.17132 -8.63108 24.1627 -3.07112 +168 2 0.561936 16.5317 5.51148 1.70853 -39.3498 23.4345 +169 1 1.0126 0.815092 9.34853 9.77893 1.05612 10.9097 +170 2 1.24172 0.537916 10.2451 4.93082 3.28815 4.21298 +171 2 0.133534 0.483606 9.24599 -18.3012 -2.93221 -7.23643 +172 1 16.7899 2.36695 13.4143 1.34336 11.0529 -24.546 +173 2 16.9036 2.71504 12.491 -0.235106 -7.90147 26.8103 +174 2 16.4417 1.47344 13.309 3.25474 -1.82726 5.59598 +175 1 2.66167 16.0077 12.0598 12.6303 -22.6944 6.71055 +176 2 3.01062 15.6298 12.8947 -8.01809 9.38789 -15.4913 +177 2 3.11281 15.5097 11.3415 -7.7677 12.8204 10.8964 +178 1 16.364 15.512 6.14932 19.0855 9.58845 -19.9598 +179 2 17.3177 15.4404 6.40388 -23.0707 9.20906 -7.80583 +180 2 16.2465 16.2844 5.52559 8.28806 -24.9431 19.8586 +181 1 5.77951 5.20043 11.8033 8.47507 -20.9263 -15.707 +182 2 5.6405 6.00993 12.2754 -6.27864 14.793 10.9641 +183 2 5.18835 4.5564 12.2066 -2.11002 -1.11499 -2.91817 +184 1 15.1794 4.92089 0.775894 -18.0102 -8.76269 31.4284 +185 2 14.9497 4.67568 1.72392 8.26683 8.97624 -32.6089 +186 2 14.3636 5.23769 0.366515 4.70525 -0.664057 3.69432 +187 1 16.3975 16.4382 1.83859 15.8969 -1.83249 -31.9545 +188 2 16.3175 16.7184 2.73629 -8.02889 11.6848 21.5541 +189 2 16.8259 17.1655 1.34034 -8.03244 -7.80667 10.4102 +190 1 0.153841 4.83744 3.963 18.3567 41.8245 -8.83163 +191 2 0.481764 5.78512 3.86014 -17.0028 -34.1388 7.97498 +192 2 0.952119 4.32423 4.11352 -0.77715 -2.59924 4.82879 +193 1 2.94647 15.0748 15.1079 -17.5423 -9.74792 39.2804 +194 2 2.84668 14.6538 16.0052 7.88621 4.55617 -28.9019 +195 2 2.37581 15.8415 15.2342 5.36547 9.02165 -11.4736 +196 1 1.04118 14.6398 9.41517 21.0794 -20.4815 -17.0137 +197 2 1.63478 13.9208 9.06194 -19.3512 25.5288 8.96267 +198 2 0.7851 14.3144 10.2695 -7.28135 -4.68142 11.1743 +199 1 13.5343 16.512 11.5541 0.415781 17.9887 -13.1724 +200 2 13.2087 17.3014 11.0493 5.42519 -19.6136 10.4452 +201 2 13.1525 15.7431 11.1062 -5.37134 4.1326 5.42785 +202 1 4.79073 1.57335 0.678685 -10.2425 -16.6589 -0.602312 +203 2 4.2243 2.02466 0.0269211 5.06007 -3.50169 9.95598 +204 2 4.26355 0.829094 1.04695 5.40097 16.8315 -2.73739 +205 1 1.55169 18.6011 11.9401 -14.2618 14.3088 -13.4455 +206 2 1.54559 0.423493 12.7773 -0.760074 5.21042 2.72529 +207 2 2.10509 17.8447 12.0596 11.7149 -17.0814 4.30068 +208 1 11.3926 10.0859 4.15406 35.1149 20.4659 -18.5884 +209 2 11.4922 10.6036 3.30306 -8.07316 -21.3073 26.3838 +210 2 12.3257 9.94393 4.45754 -25.8381 1.71308 -8.95455 +211 1 8.18732 12.2257 3.75704 -12.727 -0.351394 27.2441 +212 2 9.08394 12.5468 4.00553 -19.5779 -3.96369 2.83586 +213 2 7.55786 12.2705 4.55735 35.1927 2.13842 -31.3906 +214 1 14.6183 4.0143 3.36201 13.432 11.2186 16.7224 +215 2 15.2472 4.27703 4.07585 -12.4329 -9.47893 -15.9273 +216 2 13.7521 4.30159 3.67007 -0.91716 0.860244 -2.07153 +217 1 5.73358 1.67843 7.60794 -24.3615 -22.8066 38.6551 +218 2 5.03202 1.06037 7.9982 26.7251 29.011 -15.8684 +219 2 5.4689 1.83957 6.71483 -6.40801 -4.86943 -26.9957 +220 1 17.8709 0.966847 4.84319 9.19834 18.9135 -13.8104 +221 2 18.365 1.30942 4.06688 -7.16187 -11.4028 13.2983 +222 2 17.8528 1.72071 5.45189 -4.56365 -9.98849 0.137087 +223 1 6.8232 9.21412 4.53503 0.0591715 -6.07859 -16.7729 +224 2 6.61803 9.33533 5.45725 2.71524 4.28405 13.1117 +225 2 7.76963 9.02928 4.48077 0.0640272 -1.66157 1.55662 +226 1 2.43776 14.707 2.05519 12.3789 -12.7502 -17.0618 +227 2 3.26162 14.6424 2.56361 -5.44595 2.48516 -0.426941 +228 2 2.66563 14.4192 1.14611 -3.66427 9.22898 15.3942 +229 1 17.2291 12.9271 13.0675 -25.7945 34.5425 2.40746 +230 2 16.3582 13.328 13.3279 21.6203 -16.0155 -5.62376 +231 2 17.7378 13.7209 12.8173 -0.837652 -12.191 -0.563337 +232 1 14.8245 10.5613 1.47762 -19.5687 -28.1113 -12.7998 +233 2 15.3117 11.2776 1.82539 19.2978 30.1093 14.6064 +234 2 13.9052 10.723 1.70642 0.475408 2.13461 -1.67485 +235 1 5.64982 6.63563 4.55084 7.38671 -15.2963 15.0755 +236 2 5.89214 7.54949 4.44479 2.16454 16.7651 -4.4857 +237 2 6.3044 6.30345 5.19757 -6.24708 1.07556 -9.93912 +238 1 8.10845 8.3271 10.3627 -2.57156 5.78827 13.3728 +239 2 8.61892 8.85799 9.7482 5.06505 3.86155 0.738683 +240 2 7.30116 8.09886 9.91192 -6.7312 -10.1116 -10.9746 +241 1 13.4488 18.4608 5.65963 -13.3307 -19.6223 8.99938 +242 2 12.6096 0.239632 5.39678 7.81848 3.10411 6.37483 +243 2 13.1935 17.7385 6.2846 5.11891 19.4349 -8.45882 +244 1 -0.00278136 2.5625 0.408955 -12.183 35.1922 -19.112 +245 2 17.7147 2.60224 18.7259 18.9642 -9.11891 12.7486 +246 2 0.290302 3.48872 0.227759 6.22068 -26.2608 7.60118 +247 1 12.9842 10.8497 9.70117 -72.6257 27.1129 -13.2266 +248 2 11.97 10.965 9.69449 48.4921 6.31007 0.109369 +249 2 13.0048 9.91956 9.83068 16.3628 -25.292 6.36111 +250 1 0.548273 12.2593 11.2103 29.2233 3.63314 -8.31727 +251 2 18.2651 12.1894 11.4198 -11.8267 3.42799 7.99272 +252 2 1.06577 12.5175 11.9926 -12.6507 -2.71608 -2.06856 +253 1 5.24515 7.35168 13.3154 -11.9716 -5.94003 -7.6844 +254 2 5.73604 8.07931 12.9223 2.64227 5.43904 4.60776 +255 2 5.63818 7.16239 14.1672 7.7875 0.124539 4.29694 +256 1 1.16856 6.76355 12.0035 -37.5881 -40.6251 -19.8542 +257 2 0.334741 7.08942 11.6206 8.86965 -4.87383 5.4559 +258 2 1.63397 7.52151 12.2381 28.649 45.7996 14.9133 +259 1 15.5501 9.75639 12.3967 -1.92883 21.1886 15.8166 +260 2 15.1116 10.6344 12.221 21.3449 -31.3991 6.12972 +261 2 16.0605 9.85526 13.2245 -13.7753 0.465455 -14.4819 +262 1 16.5858 12.6354 5.59083 -2.62715 14.8355 -19.0185 +263 2 16.4437 13.5882 5.83081 0.436603 -22.1434 -16.2318 +264 2 16.416 12.5171 4.60718 5.48378 12.0784 33.3147 +265 1 6.40279 9.86277 0.0794915 -20.3924 -8.41649 -9.56759 +266 2 5.55524 10.218 0.380594 4.23452 2.32222 -1.66862 +267 2 7.0555 10.2042 0.674211 16.128 4.48978 14.4774 +268 1 12.2427 6.01171 4.00399 -23.1281 -36.6346 24.2315 +269 2 12.2798 6.64894 3.31747 0.117026 23.2517 -16.0656 +270 2 11.2984 5.74139 4.08171 19.6095 7.84283 -4.73597 +271 1 0.360057 12.9056 0.031807 -8.11921 2.1908 5.08387 +272 2 18.8977 13.4796 0.805411 -3.72305 -1.59029 -3.55744 +273 2 18.3786 13.2516 18.0169 7.85083 -4.92073 3.80969 +274 1 3.55677 18.7152 8.66247 19.9063 -6.335 -5.44295 +275 2 3.49677 18.1902 7.8473 -5.97778 6.84736 4.02201 +276 2 2.66917 0.348355 8.87781 -8.06089 0.921211 -3.36616 +277 1 7.26214 17.4262 4.43744 19.2672 26.0801 -3.30237 +278 2 7.75433 18.2474 4.74147 -22.4281 -27.0983 -14.818 +279 2 7.37471 17.3728 3.46226 -1.25032 2.03681 18.5343 +280 1 9.25258 17.1703 12.1759 28.8617 -14.1678 9.07352 +281 2 9.26958 16.3393 11.6513 -2.57153 16.4076 7.11435 +282 2 10.1283 17.1978 12.6604 -29.6357 0.448077 -14.593 +283 1 13.2677 13.193 7.99719 -21.1722 -32.5843 10.0566 +284 2 13.3388 12.6042 8.77917 0.104276 5.764 -17.169 +285 2 13.8077 13.9427 8.17139 23.4211 18.1414 5.93605 +286 1 14.7593 2.91325 15.4943 24.3728 -2.49696 -23.5999 +287 2 14.0361 2.3713 15.1546 2.238 -3.60609 4.01929 +288 2 15.4274 2.94021 14.7667 -15.6113 -2.56038 15.0831 +289 1 9.9738 15.6484 16.9671 -8.54083 0.59912 -5.05632 +290 2 10.1057 14.7848 16.5569 10.1368 1.85589 1.18764 +291 2 9.46144 15.457 17.7506 -1.80616 -1.66933 10.9911 +292 1 11.2344 8.55758 16.6355 7.77426 1.92795 -6.45244 +293 2 10.4646 8.11257 16.295 -8.96701 -9.58703 -5.10609 +294 2 11.6991 7.91388 17.1598 3.61158 -8.68538 8.99751 +295 1 4.14955 18.3179 16.8036 -6.71252 9.00681 -6.36217 +296 2 4.47312 17.6803 17.4466 6.33314 0.74429 2.85153 +297 2 4.24503 0.569095 17.1648 -0.42517 -11.8307 0.148866 +298 1 2.33957 4.29184 8.91302 22.2448 -7.34702 27.8454 +299 2 3.30686 4.08394 8.81247 -29.123 7.66299 4.05924 +300 2 2.12598 4.16624 9.8839 8.54186 0.354435 -34.7065 +301 1 9.95255 10.4179 9.8571 -18.8164 27.0404 -12.2944 +302 2 9.4534 11.1894 9.4744 17.3372 -21.5482 9.10503 +303 2 9.8309 10.4683 10.8129 6.92766 -2.76642 -0.156957 +304 1 9.80127 0.922938 10.8108 4.3272 3.59983 6.04006 +305 2 9.35046 0.175669 11.2139 0.840012 -6.18623 1.13214 +306 2 9.1369 1.38463 10.2905 0.460774 -0.831922 -5.90435 +307 1 9.16459 15.1765 10.2101 -26.8722 -7.06493 -21.2153 +308 2 8.97785 15.8968 9.57551 3.0406 -6.31351 13.2231 +309 2 8.39419 14.5643 10.0571 23.5779 16.7742 11.4525 +310 1 0.773683 9.7544 10.1833 18.261 11.1305 -23.2394 +311 2 0.868202 10.7262 10.3345 -3.82315 -24.612 -0.100636 +312 2 1.30536 9.53677 9.37727 -17.4146 8.84667 24.1623 +313 1 17.2096 4.87642 8.04469 -12.9959 -9.21067 35.1395 +314 2 16.3347 5.16277 8.3943 19.7751 -0.094318 -9.55648 +315 2 17.6197 4.3572 8.78272 -10.3132 11.9302 -24.4143 +316 1 14.8095 14.6496 0.0373288 -5.69372 -9.04424 21.9283 +317 2 15.5101 14.9524 0.640087 -10.906 0.748239 -2.66247 +318 2 14.0769 14.3265 0.613297 14.425 8.36295 -12.6903 +319 1 3.89537 11.0996 9.55593 -9.82967 16.3938 -0.398364 +320 2 3.93242 11.2996 10.5001 -1.21387 -1.78602 1.5381 +321 2 3.39392 11.8407 9.15947 5.2768 -13.1919 0.569667 +322 1 11.4169 10.7371 1.49225 5.47317 24.4145 -6.81884 +323 2 11.5532 11.6314 1.08329 0.074839 -23.6179 10.2373 +324 2 10.4618 10.6109 1.50924 -1.9569 -1.96948 -2.8184 +325 1 13.1395 7.21524 12.5729 -20.455 -7.16835 0.858137 +326 2 14.0577 7.03675 12.4308 23.1896 -1.74136 0.0778831 +327 2 12.7378 6.3322 12.608 -1.47964 6.92135 2.9072 +328 1 9.65614 1.96645 0.86496 18.1931 4.09637 20.8777 +329 2 8.84682 1.67677 0.484793 -23.8326 -3.90796 -8.97572 +330 2 10.1746 2.31935 0.150168 8.91513 5.01659 -9.40528 +331 1 10.6386 13.4197 4.53193 2.28663 -4.65747 18.8344 +332 2 11.4948 12.9639 4.69275 -16.1918 12.7288 -0.469196 +333 2 10.3958 13.8423 5.38242 9.30576 -5.17735 -13.1714 +334 1 14.5273 1.57884 10.9459 15.1221 22.4117 -0.776229 +335 2 15.362 1.31139 10.5257 -10.7732 -5.17355 3.70166 +336 2 14.6474 2.54531 11.0746 -6.11584 -12.5888 -6.32845 +337 1 14.4766 12.0159 11.6273 -10.9263 4.56586 -44.1867 +338 2 15.2047 12.4077 11.0864 -12.0042 -9.95663 15.0185 +339 2 13.8634 11.5981 10.9451 22.3117 17.3775 30.6101 +340 1 8.16847 5.14124 9.81669 -29.5484 17.7318 23.7918 +341 2 7.27475 5.12719 10.2684 30.6512 -1.40914 -16.6308 +342 2 8.33799 4.26267 9.50012 -3.06916 -18.2431 -3.24008 +343 1 1.5108 16.9662 18.5044 9.55151 26.7901 -23.2493 +344 2 1.84435 17.2897 17.6363 -7.76754 -5.77411 19.656 +345 2 1.83481 16.0826 18.5596 5.96378 -22.3257 1.76596 +346 1 1.42717 17.3886 15.3379 47.0554 -13.0927 -7.45492 +347 2 1.50543 18.1882 15.8264 3.14075 27.3625 12.617 +348 2 0.523906 17.2066 15.2924 -49.7083 -12.5335 -2.74225 +349 1 3.49173 5.73723 6.04987 -5.63889 12.5308 6.32322 +350 2 3.05134 6.46754 6.5425 11.5005 -15.9447 -9.63575 +351 2 4.14223 6.14285 5.45548 -4.8412 1.1033 3.2125 +352 1 12.5916 9.51872 14.2408 10.4293 -27.0271 -12.8548 +353 2 13.028 8.79356 13.6831 -19.628 26.0366 30.4849 +354 2 12.3513 9.14884 15.1174 6.55215 0.813797 -17.5332 +355 1 4.09544 15.2089 7.12218 31.8609 13.6269 2.32941 +356 2 3.67616 16.0257 6.80924 -1.84113 -5.17266 1.34804 +357 2 5.07546 15.4284 7.13078 -32.8392 -10.6488 -3.17146 +358 1 0.799143 8.79431 15.1488 8.21516 12.8732 -16.9375 +359 2 0.575284 9.7423 15.0796 -2.5473 -12.0602 5.3867 +360 2 1.52676 8.70151 14.5038 -8.32138 -2.51513 8.31525 +361 1 12.8725 8.28632 10.0993 13.5644 -10.3417 -12.785 +362 2 13.6812 7.81606 9.78663 -13.8637 7.80766 13.5238 +363 2 12.7502 8.10095 11.0322 6.24745 -8.27276 5.3213 +364 1 15.2423 7.98405 3.44353 15.6799 19.5655 -11.9659 +365 2 14.4463 7.83544 2.89643 5.54982 -16.2362 17.4101 +366 2 15.5184 7.39607 4.17406 -22.72 2.15229 -11.0841 +367 1 17.1687 6.76019 0.0376092 -10.314 6.5713 -12.413 +368 2 16.7239 5.93548 0.292072 -0.0664332 9.88195 -1.29815 +369 2 16.4741 7.34647 18.2846 16.8516 -16.4801 16.1304 +370 1 8.96925 6.98328 7.86383 -27.8745 -15.8066 22.0328 +371 2 9.86939 7.24269 7.81058 30.3142 9.1639 -3.03437 +372 2 8.87474 6.48936 8.713 -1.39219 10.6855 -19.1169 +373 1 12.482 0.614891 1.23015 1.92335 -8.70167 1.10105 +374 2 13.2432 1.03802 1.64803 2.06157 -2.24376 -3.30204 +375 2 12.803 0.16068 0.442821 -0.913907 6.47573 3.0001 +376 1 5.66871 15.0647 14.4598 7.14191 19.2454 -5.51099 +377 2 4.75956 15.0903 14.7907 1.11348 4.01334 -3.77227 +378 2 5.94804 16.0038 14.294 -6.0872 -24.4911 3.70117 +379 1 3.73529 6.48244 1.70347 -4.32476 7.10488 -19.4811 +380 2 3.3805 7.26573 1.22404 3.0021 -10.505 14.7125 +381 2 3.73285 6.71028 2.6365 -0.71904 4.06656 1.73817 +382 1 3.86925 11.322 12.3296 2.55777 5.65869 0.326193 +383 2 4.7048 11.7602 12.5386 0.0734552 -4.93202 -1.70743 +384 2 3.20028 11.8652 12.7549 -2.96009 3.18005 0.676376 +385 1 5.3196 3.88545 15.7107 -12.565 72.4648 14.1271 +386 2 6.00107 3.31 15.4478 35.5939 -28.3589 -8.92722 +387 2 5.74724 4.80358 15.8116 -17.6513 -43.1362 -7.7855 +388 1 14.0258 10.1309 4.70784 36.378 -19.982 -23.5474 +389 2 14.2654 9.87929 5.60631 -3.02994 -1.07275 0.485782 +390 2 14.6765 9.60938 4.12831 -34.5421 20.7478 23.7761 +391 1 7.50853 17.298 8.98976 4.28677 22.6193 13.4416 +392 2 7.01472 17.6504 9.76182 0.935323 -12.9311 -15.6818 +393 2 7.87431 18.0869 8.55212 -1.49272 -9.54271 -2.09709 +394 1 4.57424 14.4015 3.77738 -1.32578 6.84514 50.6918 +395 2 4.51443 15.3073 4.2079 4.46262 -31.6709 -20.6737 +396 2 4.58351 13.7394 4.53798 -1.39317 23.0513 -31.5206 +397 1 14.2431 7.32994 15.8885 26.8814 9.55229 5.02737 +398 2 15.048 7.31796 15.3145 -19.1816 0.583054 17.9404 +399 2 14.5184 7.8184 16.7026 -8.00009 -12.2304 -19.9762 +400 1 3.00564 18.4171 1.98737 1.19435 35.3283 33.2576 +401 2 2.60973 17.9491 1.28647 -18.7059 -24.7202 -27.1582 +402 2 2.28625 0.311703 2.39571 15.2164 -11.2621 -13.5372 +403 1 7.97098 1.60459 4.54116 29.2267 3.13781 -13.0843 +404 2 7.39603 1.96083 3.86318 -8.15365 2.40339 -0.697123 +405 2 8.86388 1.74438 4.1564 -17.9094 -5.03071 12.9608 +406 1 2.50155 14.1648 17.7228 -14.4362 -20.2086 14.4505 +407 2 1.80023 13.5192 18.0233 22.5798 22.6486 -13.5864 +408 2 3.34474 13.7188 17.8802 2.38023 -0.79805 1.89101 +409 1 0.962462 1.97628 13.8796 24.0866 5.42438 -18.2963 +410 2 1.23331 1.73159 14.7528 2.00372 -3.67266 20.967 +411 2 0.0219615 1.96156 13.879 -26.3344 -0.788872 -2.58417 +412 1 4.34962 0.156713 13.8729 25.4477 -1.51409 -1.97896 +413 2 5.30295 18.5478 13.9084 -21.2168 3.6137 -4.76321 +414 2 3.99528 18.4902 14.7051 -3.29088 -0.042535 8.53213 +415 1 7.35889 1.01117 18.4602 -20.0845 2.29217 31.534 +416 2 7.53777 0.614221 17.6282 1.02155 -13.8743 -28.1328 +417 2 6.39885 0.929085 18.6632 17.4429 7.83311 -8.37388 +418 1 15.8463 18.3909 13.9448 -43.3072 10.6601 -1.92517 +419 2 14.916 18.6906 13.7723 29.0574 -10.6436 -1.66619 +420 2 15.8257 -0.445507 14.8871 10.2412 6.45473 0.424587 +421 1 10.2808 4.63783 16.2194 -42.4572 -26.934 -19.6441 +422 2 11.2059 4.65809 16.3645 33.0638 0.71496 4.62375 +423 2 10.0964 3.70704 15.9214 4.59595 26.5122 11.6188 +424 1 15.903 17.6519 4.47823 -22.6026 32.3058 18.5214 +425 2 16.5145 18.4189 4.46111 -7.58873 -12.9749 2.84853 +426 2 15.0701 18.0221 4.91498 30.26 -18.095 -22.6862 +427 1 6.91987 17.5654 13.9309 41.5981 2.12242 13.325 +428 2 7.49428 17.7119 14.7497 -22.2257 -6.74767 -31.4029 +429 2 7.56851 17.4237 13.1898 -17.2813 4.26485 21.283 +430 1 13.2143 6.40362 6.52296 -17.8609 -7.45559 2.6451 +431 2 14.0836 6.75111 6.37132 17.2928 3.48546 -1.85822 +432 2 12.8363 6.25317 5.64277 2.90235 4.29902 5.97585 +433 1 7.86013 2.26394 9.49062 -8.36252 -9.46169 -35.4407 +434 2 7.29684 2.1706 10.2513 -11.7917 -0.851936 13.7299 +435 2 7.34714 1.87564 8.72892 15.7155 15.0955 20.8405 +436 1 15.1343 14.8378 13.7575 -15.8142 13.0315 4.83039 +437 2 14.8532 15.0481 14.6708 3.35379 -3.45087 -12.098 +438 2 14.5629 15.3828 13.1802 11.493 -9.40285 7.27009 +439 1 9.38118 8.39884 3.83519 4.0123 -7.74443 -2.87465 +440 2 10.2467 8.83344 3.97294 -13.6344 -10.1795 -2.34121 +441 2 9.51993 7.43201 3.84247 0.270426 14.3255 0.324032 +442 1 17.6982 13.5806 16.4882 -11.1823 29.4115 -15.1875 +443 2 16.7477 13.4163 16.452 -1.16521 -4.14372 2.83933 +444 2 17.7994 14.4458 16.0124 3.95943 -25.1425 10.6502 +445 1 4.93057 10.3937 2.82949 21.3493 0.31084 -7.87351 +446 2 5.82872 10.0425 3.0149 -20.5327 4.11374 3.5741 +447 2 4.70497 10.9363 3.59521 3.63155 -1.89772 -0.291932 +448 1 3.65557 8.40975 9.92882 -7.92631 -13.4411 16.4299 +449 2 3.66668 9.34394 9.72247 1.00161 8.70404 1.26029 +450 2 3.36367 8.33438 10.8592 4.36465 5.8519 -13.4993 +451 1 15.9508 6.91708 5.85912 26.4071 -7.62551 -3.83966 +452 2 16.729 7.34279 6.26867 -14.5536 -3.6129 -4.6023 +453 2 16.2929 6.05819 5.53033 -12.7649 13.2481 9.54942 +454 1 15.2478 7.26488 8.9948 -11.5397 21.0457 -23.7706 +455 2 16.0349 7.57374 9.47019 -5.83 4.16597 -2.61919 +456 2 14.9977 7.92652 8.27445 16.2337 -23.38 28.7542 +457 1 6.17715 12.7863 12.74 7.06624 23.8889 14.8517 +458 2 6.98998 12.4152 13.1111 -3.934 -5.41615 -1.6338 +459 2 6.02064 13.6181 13.2483 1.6805 -16.267 -10.1818 +460 1 12.1255 4.53395 13.1266 36.5984 28.8141 18.352 +461 2 12.1988 4.68857 14.088 4.72218 -0.985297 -9.83354 +462 2 11.344 4.04995 13.0228 -42.0246 -23.4808 -8.79261 +463 1 11.4542 8.08345 7.86287 23.2187 -10.867 14.4494 +464 2 12.2022 7.55078 7.50013 -20.6002 10.1652 -0.104446 +465 2 11.6749 8.16233 8.821 -5.77941 1.62242 -23.2927 +466 1 16.9966 10.8 7.60022 14.0465 -17.3895 -10.8701 +467 2 17.6655 10.1188 7.31004 -18.6815 22.6831 6.1404 +468 2 16.8855 11.476 6.90625 3.56282 -12.242 0.823841 +469 1 5.28409 18.0615 10.7272 -25.4136 -4.73004 -4.09376 +470 2 4.85025 17.4105 11.3211 10.0924 14.2936 -14.0097 +471 2 4.61921 18.235 10.0106 18.3134 -6.11244 18.1083 +472 1 7.63344 17.4775 1.60819 -12.3126 -2.35291 35.094 +473 2 8.06049 16.702 1.26786 10.3266 -12.472 -14.3961 +474 2 7.64482 18.174 0.971148 2.96613 14.6858 -21.2308 +475 1 1.92556 12.9088 13.6099 -6.92879 6.84011 17.0322 +476 2 1.40166 12.3078 14.1747 6.51182 9.66465 -5.96466 +477 2 2.01688 13.7519 14.1152 3.80073 -20.221 -11.3532 +478 1 9.32296 6.74742 14.7603 -6.16505 19.9578 -6.21839 +479 2 9.80961 6.04203 15.1542 10.8193 -23.4577 14.2182 +480 2 9.81429 6.97553 13.9666 -4.58884 0.0213979 -5.59057 +481 1 15.2687 4.29028 10.7744 -16.6773 -11.1812 -9.87371 +482 2 16.185 4.03181 10.6852 9.89086 1.55812 4.86514 +483 2 15.2046 4.88146 11.5266 6.28069 5.56792 1.9642 +484 1 11.3833 6.23863 0.0689293 -3.19885 -6.29427 4.65322 +485 2 11.5449 5.27036 18.7473 -10.1654 17.1623 -6.02864 +486 2 10.4171 6.41156 18.6664 16.019 -11.974 -2.10863 +487 1 18.4779 11.4738 14.9298 -4.11302 6.12113 -30.5228 +488 2 18.0937 12.0014 14.1715 8.36132 -18.8326 26.0479 +489 2 18.3027 12.0103 15.7035 0.536699 7.83234 4.13522 +490 1 7.03799 9.27423 7.33397 -11.8444 -18.9096 15.35 +491 2 6.61404 8.50211 7.787 12.2323 17.6714 -16.3801 +492 2 7.97664 9.07639 7.31215 4.33333 -2.45816 -2.54611 +493 1 18.3885 15.3347 12.1965 11.3664 3.9942 -3.56245 +494 2 0.676524 15.5664 11.9851 -14.9026 2.39255 4.26485 +495 2 17.8062 15.8491 11.6143 4.55299 -1.04774 1.98359 +496 1 16.551 4.342 5.30396 -29.3567 -2.30965 40.8017 +497 2 16.5003 4.35995 6.30392 8.99046 -4.55546 -31.3189 +498 2 17.4312 4.58446 5.06774 26.2551 1.0485 -9.7407 +499 1 17.7614 3.18175 10.7726 14.454 -1.68376 5.55906 +500 2 18.6848 3.25815 11.0867 -17.2868 6.635 -4.74284 +501 2 17.731 2.30667 10.3896 -4.78084 -7.5669 -7.23363 +502 1 12.3288 18.6185 10.0887 4.81564 48.0444 9.66027 +503 2 11.5224 0.4701 10.402 18.5752 -22.9317 -12.6203 +504 2 13.04 0.683861 10.1001 -20.831 -28.6711 -0.571217 +505 1 10.4023 9.75891 12.5069 9.56908 10.7357 22.5843 +506 2 11.0968 9.84844 13.1991 -9.82495 1.00858 -15.0243 +507 2 10.3005 8.81694 12.4067 -0.389825 -11.0581 -5.16736 +508 1 0.728244 2.62509 7.20528 10.511 21.9286 8.67284 +509 2 1.10851 3.44304 7.59367 -9.47208 -14.047 -5.98037 +510 2 0.946108 1.9669 7.86838 0.119732 -6.07738 -1.41007 +511 1 0.301432 15.3195 6.88989 15.9737 -48.0831 -14.5816 +512 2 0.502768 15.5752 7.7858 2.08568 -2.79341 12.7124 +513 2 0.620951 14.3521 6.81024 -17.8336 49.2232 -1.9498 +514 1 17.0496 6.91172 14.9593 8.8057 -4.67917 1.70395 +515 2 17.812 7.50707 14.8676 -6.01141 -3.19386 0.836122 +516 2 17.3983 6.09137 15.355 -4.50622 8.29661 -2.9861 +517 1 9.11865 12.5108 8.02933 -49.9881 -7.42173 -16.2711 +518 2 9.47674 11.8107 7.47486 8.95817 -5.21768 -2.38673 +519 2 8.15231 12.5395 7.74329 38.6911 2.79466 15.4325 +520 1 1.1334 1.67756 2.81686 3.27117 15.7614 -6.58164 +521 2 0.957986 2.31477 2.10151 -6.66947 -14.3695 3.78127 +522 2 1.78538 2.12055 3.36586 -0.578909 1.22693 6.40118 +523 1 4.20106 15.0562 10.0364 -13.4085 1.18971 -5.18923 +524 2 3.93003 15.0868 9.10675 3.70212 3.27773 4.96515 +525 2 5.05647 14.6363 10.0432 10.3336 -3.36269 -1.32379 +526 1 7.40784 2.22679 14.822 -4.38879 4.63456 3.27925 +527 2 7.05629 1.62422 14.1639 1.19517 -1.6595 -3.72526 +528 2 7.83793 2.94849 14.3413 -6.72155 -4.85002 1.32971 +529 1 18.3301 14.5327 2.1542 24.8671 -25.4621 4.78212 +530 2 0.57397 14.7195 2.50861 -8.4973 4.51839 -6.64425 +531 2 17.8578 15.3422 2.05909 -12.5294 22.9533 -1.13776 +532 1 10.0489 2.71902 12.9028 6.85621 -14.8278 -12.6664 +533 2 9.96638 2.08865 12.1549 1.47254 10.1846 11.5218 +534 2 9.24995 3.25129 12.8895 -2.74325 3.95657 -0.856162 +535 1 2.95855 8.84401 12.9769 -19.5266 -12.9618 -2.46154 +536 2 3.45638 9.64099 12.8192 4.11354 12.8609 -3.4499 +537 2 3.6113 8.17746 13.175 10.7686 -6.78904 5.39462 +538 1 3.18595 8.60313 3.78164 6.49512 -8.67182 57.5105 +539 2 3.58728 9.20701 3.1814 16.1034 15.9636 -13.6327 +540 2 3.51933 8.8716 4.70776 -18.429 -13.2453 -44.8458 +541 1 5.73851 7.25721 8.5964 -4.13987 -1.96532 11.6754 +542 2 5.69005 6.29369 8.53393 1.30439 2.87011 -1.70973 +543 2 5.04632 7.51192 9.22575 1.66035 -1.11756 -5.95213 +544 1 14.9081 1.62503 1.83745 -8.73365 -28.3512 -14.8102 +545 2 15.1675 2.29904 2.4498 2.46531 19.8996 4.15138 +546 2 15.1848 1.81402 0.924567 6.2551 4.83326 15.3454 +547 1 8.63912 15.0489 0.67096 1.85438 -3.84451 5.87273 +548 2 9.43742 14.948 1.21756 -6.6173 4.03251 -1.68679 +549 2 7.96284 14.4978 1.10066 2.22069 5.93818 -4.9944 +550 1 15.4364 1.44293 7.19944 -29.9197 -3.33934 -17.0244 +551 2 14.7125 0.994492 6.68707 24.0317 7.87524 16.0302 +552 2 15.0797 2.33705 7.33252 4.46076 -6.95989 4.74521 +553 1 4.93029 12.8913 18.4644 10.9792 1.21933 18.1223 +554 2 5.27563 12.987 0.740174 -6.01723 -1.47567 -19.726 +555 2 5.68015 13.1369 17.9044 -5.07302 3.16897 2.74711 +556 1 15.3923 8.68146 18.054 15.694 19.9465 -16.5309 +557 2 15.9315 9.21769 17.4147 -18.0717 -17.5644 15.7946 +558 2 15.1857 9.29971 0.121687 -1.56315 -2.75746 2.59172 +559 1 11.9784 3.14039 18.3403 11.1408 -7.29272 18.8649 +560 2 12.1001 2.9975 0.653392 -4.70819 -0.503108 -12.7749 +561 2 12.4778 2.40933 17.9385 -7.35096 7.48199 -3.86664 +562 1 13.1896 12.7267 5.18606 4.81883 -3.59528 0.0329893 +563 2 13.4958 11.8346 4.97314 2.3467 3.28367 -0.068752 +564 2 13.4618 12.8881 6.09814 -4.13789 -2.12194 -0.520265 +565 1 6.18108 7.13483 0.245639 -8.98659 -24.3205 -5.24363 +566 2 6.15368 8.0627 19.0493 5.02048 26.2765 -0.395042 +567 2 5.28324 6.84248 0.444666 1.40419 -2.69741 2.9636 +568 1 17.7469 15.8806 14.9091 -16.6307 4.82259 1.60218 +569 2 16.7811 16.0196 14.9781 16.1488 -1.66255 -6.01934 +570 2 17.9228 15.7652 13.9648 -0.217809 -0.705292 2.49903 +571 1 13.1074 0.925484 16.7107 3.18003 -6.63181 9.52558 +572 2 14.0398 0.701227 16.9047 -10.9319 3.14101 -7.94235 +573 2 12.6435 0.0729893 16.6565 6.11054 4.53406 -2.82687 +574 1 10.8779 14.5049 7.42771 23.1657 22.4115 -16.2389 +575 2 10.1426 13.9786 7.6854 -20.2069 -15.6201 11.4355 +576 2 11.6544 13.9411 7.50544 0.873985 -2.97227 1.69423 +577 1 17.7332 8.41688 2.16357 9.83329 25.3003 13.1733 +578 2 16.8474 8.49196 2.51389 -11.5025 -5.56634 1.51969 +579 2 17.684 7.86174 1.40275 -6.79002 -17.3841 -17.6814 +580 1 12.5241 7.78132 2.0423 -1.44154 17.0415 -14.1456 +581 2 12.3356 8.69211 1.74465 0.56853 -10.9135 10.1338 +582 2 12.0507 7.22418 1.41137 4.13261 -1.84431 -3.3422 +583 1 12.0402 14.5123 10.5082 -18.3289 -2.04433 -49.0296 +584 2 12.3885 14.3833 9.58045 -11.5085 2.39427 35.0464 +585 2 11.0712 14.6752 10.3612 24.5139 -2.29095 9.58119 +586 1 6.7433 6.75035 15.5111 8.69017 25.9379 21.8943 +587 2 7.64047 7.11596 15.2998 -22.3365 -16.355 4.27733 +588 2 6.42641 7.26782 16.2896 9.37622 -14.6905 -17.8302 +589 1 7.9604 4.42511 13.2728 28.7823 16.7879 24.018 +590 2 7.37747 4.63038 12.5661 -23.4436 4.48442 -18.6585 +591 2 8.25373 5.30295 13.5968 -1.99494 -17.578 -1.9241 +592 1 13.2943 12.2257 14.4027 3.56556 -5.33332 1.41443 +593 2 13.2861 11.2546 14.3815 -5.78887 6.10336 -0.82645 +594 2 13.6298 12.4878 13.5348 -0.194802 0.853385 3.24808 +595 1 14.4975 9.60743 7.32851 -1.81828 -22.5371 -11.9494 +596 2 15.283 10.0905 7.53237 20.8949 12.3364 4.94663 +597 2 13.7862 10.0745 7.73482 -16.3884 10.3496 13.6544 +598 1 12.6855 16.7955 3.35468 10.446 54.0378 -9.24021 +599 2 12.8247 17.4169 4.11373 -2.43161 -22.9959 -18.5255 +600 2 12.7287 17.4093 2.56008 -5.07923 -25.2307 27.5772 +601 1 0.985851 7.00227 17.3383 1.31889 9.4813 -6.51378 +602 2 0.174673 6.82729 17.8428 -2.72668 6.21708 -7.63644 +603 2 0.788987 7.63656 16.6124 1.43967 -10.9643 14.4702 +604 1 12.9703 4.85252 15.7444 36.7131 7.67865 -11.6648 +605 2 13.7444 4.28338 15.4912 -28.1266 12.6425 14.7219 +606 2 13.3848 5.73698 15.8318 -12.3641 -9.92719 -0.136909 +607 1 2.31739 3.41657 5.06312 -13.6796 12.8802 45.0615 +608 2 1.71742 3.03519 5.77756 22.5616 7.27981 -29.9715 +609 2 2.67638 4.25091 5.49055 -8.69432 -27.9074 -22.1065 +610 1 8.14626 10.9014 13.7501 23.1519 -21.2188 51.9658 +611 2 8.18961 10.6456 14.7569 -3.14293 16.1916 -66.8861 +612 2 8.91613 10.442 13.3487 -9.38929 12.2654 3.7561 +613 1 12.9965 1.57692 13.2293 -13.236 30.2614 -33.2276 +614 2 13.5053 1.61767 12.3799 -8.92772 -10.8244 27.0208 +615 2 12.3556 2.33631 13.1194 22.5086 -26.9187 11.5847 +616 1 6.63966 13.684 2.03193 -11.5531 1.65982 24.7971 +617 2 6.01437 14.0711 2.69678 13.9712 -7.1585 -19.9778 +618 2 7.21702 13.1132 2.57076 -4.92077 5.61769 -6.96253 +619 1 15.813 6.37449 12.4855 -26.0384 -19.2076 5.56376 +620 2 16.3133 6.94665 11.9354 17.458 16.492 -16.919 +621 2 16.1081 6.5465 13.3734 10.1637 1.50607 12.5345 +622 1 16.7517 0.683836 9.54032 9.17465 -17.8268 3.86543 +623 2 16.8312 18.3701 9.76674 -11.2714 16.7378 -3.92594 +624 2 16.3182 0.76443 8.67683 0.0107679 -1.03064 0.242674 +625 1 6.19528 11.6935 8.23629 -2.98771 -55.3704 13.0415 +626 2 5.39217 11.4329 8.74625 16.1659 14.5788 -12.0119 +627 2 6.59624 10.789 8.03203 -10.8651 41.6219 1.75135 +628 1 2.78257 8.63233 0.349942 -51.0927 -6.02203 -19.4773 +629 2 2.14734 8.16991 18.3384 31.254 20.3071 31.1367 +630 2 2.20011 9.24624 0.868363 16.6862 -13.9373 -14.0055 +631 1 10.0933 10.2699 6.60791 4.69659 2.91801 -6.95173 +632 2 10.6585 9.65933 7.0984 -2.33853 -1.64778 -0.152736 +633 2 10.478 10.3114 5.71024 -7.38541 0.394324 12.3102 +634 1 6.85971 15.7454 6.78123 4.24276 8.06212 3.90305 +635 2 7.14611 16.2575 7.56121 -6.95129 -7.98507 -8.49325 +636 2 7.04221 16.3283 6.02778 -2.00154 -5.2395 1.03704 +637 1 6.5672 12.9167 5.89107 0.597921 -4.77378 -3.41809 +638 2 6.75629 13.7931 6.22612 0.282518 9.70238 2.49815 +639 2 6.16516 12.4266 6.61937 1.75727 3.9196 -1.62353 +640 1 16.7395 12.5246 9.74847 -3.06854 -10.3396 -13.3378 +641 2 16.803 11.7934 9.09918 0.0574675 11.3505 13.7779 +642 2 17.2471 13.2388 9.35461 0.0307086 0.265441 4.69208 +643 1 6.27963 2.83254 2.76143 -4.73524 -28.0523 14.6006 +644 2 6.37898 3.73989 2.5277 5.16678 22.951 -10.7112 +645 2 5.79937 2.39077 2.0523 -0.657158 4.14199 -3.99187 +646 1 10.6834 2.9997 3.2493 -4.30343 6.66703 3.45031 +647 2 10.3389 3.87773 3.47337 -2.10815 -7.43082 -2.74741 +648 2 10.1644 2.67816 2.50044 1.52937 0.706493 -1.87803 +ITEM: TIMESTEP +100 +ITEM: NUMBER OF ATOMS +648 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +0.0000000000000000e+00 1.8643000000000001e+01 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.77244 6.59569 17.9763 -3.45079 -15.6041 -9.13306 +2 2 7.88004 6.49722 18.3444 6.65526 3.83231 -3.73646 +3 2 8.88832 5.875 17.3232 0.339998 10.7344 11.2284 +4 1 0.232197 8.43163 6.74931 6.06809 -9.75314 40.4456 +5 2 0.255717 8.25928 5.82997 0.568886 -7.03857 -37.2819 +6 2 0.690537 7.6579 7.15764 -12.6716 20.3857 -3.7924 +7 1 8.73054 0.448274 6.96197 0.757688 5.19807 -2.99354 +8 2 9.64384 0.493158 6.62895 -11.5479 0.592924 -0.0248858 +9 2 8.1978 0.998025 6.35807 9.15448 -7.13553 5.61176 +10 1 6.40593 1.75267 11.8149 38.8296 -3.08614 -8.28972 +11 2 5.81968 2.38515 12.1727 -25.8813 19.5399 13.38 +12 2 5.91601 0.958217 11.6787 -14.9693 -21.4487 -5.83463 +13 1 6.93553 5.46707 2.3717 -29.4847 3.29264 10.9289 +14 2 6.2293 5.77948 3.0367 33.3819 -5.43232 -34.2308 +15 2 6.73101 5.82483 1.47662 0.276644 1.33511 28.97 +16 1 16.2706 10.1725 16.0328 16.576 -12.0275 -13.9735 +17 2 17.1689 10.3287 15.6909 -13.6837 1.56601 5.28727 +18 2 15.9002 11.0264 16.2303 -5.40144 13.1923 2.47446 +19 1 10.8573 14.9713 2.3127 -4.53536 -0.807355 -13.4682 +20 2 10.8458 14.5197 3.15612 -3.95698 -5.41896 6.20362 +21 2 11.2908 15.8056 2.48855 3.23834 4.77246 6.19277 +22 1 17.2232 8.21136 11.0033 2.73792 2.45641 -7.11401 +23 2 16.6726 8.88418 11.4331 2.86084 -2.93597 -0.581414 +24 2 17.9525 8.69866 10.5809 -6.6523 -2.55116 4.88578 +25 1 14.5937 16.0509 16.2923 16.8919 1.55785 -12.0612 +26 2 13.6919 16.3738 16.3176 -7.99874 0.738503 2.77307 +27 2 14.7362 15.4806 17.0483 -6.38665 -4.70858 10.3974 +28 1 12.1782 13.2488 0.556058 -6.41896 9.17153 -4.9038 +29 2 11.8393 13.4134 18.3136 3.64438 -6.73296 -6.87976 +30 2 11.6781 13.8768 1.08938 4.30308 -0.940018 9.70193 +31 1 9.32636 5.50189 3.85673 -23.6707 -6.9557 11.6523 +32 2 8.85207 5.35955 4.73387 10.6863 3.91607 -36.7024 +33 2 8.65492 5.41152 3.1282 11.356 3.18621 25.5004 +34 1 1.53424 3.89903 11.544 -4.66799 23.5976 14.1629 +35 2 1.33558 4.79151 11.9229 9.77101 -18.0042 -9.49869 +36 2 1.78943 3.33535 12.2834 2.68741 0.460061 1.88957 +37 1 2.11036 6.99869 8.11066 2.48315 -17.2899 2.96853 +38 2 2.57184 7.49315 8.78305 3.29023 12.1045 5.89357 +39 2 2.1177 6.10606 8.48449 -3.4025 -1.3508 -8.01694 +40 1 5.18347 4.46977 7.78792 -2.57538 4.03359 -5.12796 +41 2 5.37117 3.51932 7.65443 -4.82345 11.4027 -0.558597 +42 2 4.53495 4.79047 7.12216 11.4175 -13.4448 8.55636 +43 1 3.42716 2.88114 17.3924 1.12201 37.8538 -2.09818 +44 2 4.03218 3.21565 16.6954 -8.80258 -2.8612 13.6459 +45 2 2.96175 3.68375 17.7714 12.3959 -28.5801 -12.8282 +46 1 7.56049 5.45137 6.19682 -11.2764 11.7759 39.3451 +47 2 8.17338 6.02323 6.733 -17.9712 -15.9787 -15.2388 +48 2 6.83707 5.19934 6.84169 25.8687 -1.03041 -23.6459 +49 1 9.81873 7.03274 12.0818 18.6926 1.80354 21.1658 +50 2 10.1168 6.17447 11.801 2.37707 -8.57843 -5.75387 +51 2 9.13705 7.28384 11.4839 -21.9155 5.9942 -18.2818 +52 1 13.9782 3.81734 8.11005 -6.38125 -7.14222 -11.0636 +53 2 13.4268 4.53125 7.77431 4.97705 1.71109 -4.47031 +54 2 14.3288 4.12395 8.93436 6.50574 7.00298 17.9277 +55 1 4.54162 17.1358 3.87887 10.9044 35.7056 -0.341992 +56 2 5.36932 17.5648 4.19271 -11.2647 -17.0231 -6.60056 +57 2 4.14672 17.8103 3.27983 -0.0256371 -21.9717 9.98561 +58 1 16.2123 16.5489 10.6095 26.1835 -5.76397 -19.4616 +59 2 15.4589 16.7003 11.1416 -23.8325 7.35421 23.2226 +60 2 15.8886 15.8767 10.0022 2.98718 1.98497 -7.14015 +61 1 1.93449 4.79928 0.00082377 17.3961 -4.98991 5.57961 +62 2 2.67896 5.07161 0.592242 -22.0191 7.26131 -10.4701 +63 2 1.68005 5.53286 18.0583 5.78187 -2.17332 10.5029 +64 1 11.1761 13.3033 16.4476 20.6858 -29.5101 -20.5449 +65 2 10.7502 12.4348 16.5818 -0.505604 15.8506 2.04497 +66 2 11.8189 13.0874 15.7254 -14.483 14.0049 15.9552 +67 1 10.0082 10.9133 16.7377 -9.76065 -12.5647 6.43928 +68 2 10.4104 10.0696 17.0143 -3.0625 14.8211 -5.5238 +69 2 9.04798 10.758 16.6751 14.6534 4.77532 0.819581 +70 1 11.8926 17.5507 13.5059 -15.5524 -14.4544 -0.25773 +71 2 12.4585 17.1847 12.8152 4.41482 5.53476 3.60851 +72 2 11.9755 18.5016 13.5139 9.00416 11.9454 -7.12981 +73 1 6.39659 9.54323 12.3526 -12.6063 6.46711 4.93213 +74 2 6.97402 9.29797 11.635 9.25294 -5.21247 -6.5221 +75 2 6.9248 10.0607 12.9773 -1.49192 -5.83682 -8.37915 +76 1 16.2827 12.8664 2.8283 0.430065 -24.2056 0.300325 +77 2 17.1271 13.2094 2.55074 10.9303 3.80489 0.0707423 +78 2 15.7284 13.6342 2.87288 -15.0446 12.1841 2.12753 +79 1 0.782434 12.8185 5.85612 -33.4557 3.27495 -26.778 +80 2 1.12737 12.9122 4.94214 -3.16706 -8.15793 13.9432 +81 2 18.4302 12.7528 5.74133 33.3816 -1.67566 5.80796 +82 1 5.29416 16.3645 18.462 -0.365113 -1.85929 1.37874 +83 2 5.65117 15.5929 17.9841 -1.41418 12.24 9.00358 +84 2 5.90904 16.5787 0.535619 -2.78951 -3.81837 -4.76209 +85 1 0.717617 7.68269 4.16298 45.78 12.5398 -25.9452 +86 2 0.140595 7.95484 3.42088 10.68 -3.85526 14.32 +87 2 1.67421 7.98176 3.89702 -61.12 -15.169 17.2669 +88 1 3.20538 9.16537 6.53153 -16.7997 -26.3462 11.633 +89 2 3.63886 8.66012 7.25517 -10.7634 14.1338 -16.8685 +90 2 2.28456 8.785 6.4428 29.8979 17.6904 5.8263 +91 1 7.3492 10.4558 16.1821 -32.1717 -5.51262 30.2531 +92 2 6.6595 11.1272 16.0448 13.9154 -6.26319 -1.99334 +93 2 7.03952 9.99344 16.9918 7.69449 10.9592 -10.5833 +94 1 10.9926 0.857119 5.02234 -5.32556 5.69944 -21.4369 +95 2 11.0071 1.72344 4.58448 5.20867 -2.07691 11.6276 +96 2 10.6449 0.320945 4.28448 4.96755 -3.65716 14.4683 +97 1 4.17972 2.99732 13.1563 8.08367 -30.8511 5.02994 +98 2 4.53886 3.3528 13.9956 -8.94088 -10.2248 -10.148 +99 2 4.12323 1.98418 13.2207 2.50903 42.0947 6.54014 +100 1 8.52337 10.2728 1.80778 10.3789 -10.908 24.8689 +101 2 8.43412 10.9106 2.54849 -2.4679 -8.46295 -11.8092 +102 2 8.72683 9.4118 2.24878 -4.48166 20.4458 -7.62428 +103 1 10.3146 1.66303 15.4651 0.0280032 6.46587 3.16016 +104 2 11.2365 1.5769 15.7049 7.71736 -2.87845 -0.628854 +105 2 10.2832 2.03916 14.5766 -0.873711 -2.30994 -1.44208 +106 1 2.60872 12.9688 7.93078 -1.0685 2.90827 1.70102 +107 2 3.08524 13.7852 7.70925 1.81136 -8.54773 -5.41906 +108 2 2.07592 12.7429 7.1537 2.1601 3.22826 4.8584 +109 1 3.84139 11.714 4.98357 -9.2182 -6.48315 2.00023 +110 2 3.59649 11.1336 5.73363 3.13206 7.92599 -15.0555 +111 2 3.08391 11.75 4.36582 7.48234 -0.753218 11.1676 +112 1 6.65636 14.539 16.9808 1.14971 -3.74934 -0.345026 +113 2 7.45699 15.0461 17.1534 0.734042 -3.82079 -1.22553 +114 2 6.35462 14.7758 16.0963 4.10604 -0.420587 -1.60546 +115 1 14.2186 14.4753 3.18712 8.31434 -1.03143 -11.3814 +116 2 13.7635 15.2982 3.34662 -3.59872 10.6386 -1.06184 +117 2 13.8465 13.8568 3.80574 -6.38377 -9.35153 11.7656 +118 1 8.76639 18.036 16.1575 -17.2352 -7.71273 4.18589 +119 2 9.29865 17.253 16.446 -1.99578 26.3863 -16.3924 +120 2 9.21082 0.13577 15.7005 10.7734 -16.3176 12.3305 +121 1 4.70057 1.84937 4.90583 -5.59427 22.8387 -36.2464 +122 2 3.793 2.25175 4.86575 28.8401 -10.2604 4.23254 +123 2 5.1801 2.18711 4.08016 -18.9233 -12.3263 38.2061 +124 1 15.0501 12.6021 16.5687 -12.0311 0.26828 5.88874 +125 2 14.6786 12.8761 17.4109 9.53333 3.55003 6.01908 +126 2 14.2645 12.5148 16.0221 4.98358 -1.43573 -15.5641 +127 1 15.7004 18.5129 16.8573 39.713 -3.42746 23.3516 +128 2 16.4681 18.7143 17.5055 -38.5977 -15.0096 -30.817 +129 2 15.6109 17.5396 16.7903 -2.54574 14.9499 6.02131 +130 1 1.36802 1.35817 16.6529 -7.19601 7.74866 13.6684 +131 2 2.15913 1.86948 16.876 -3.57304 -8.28302 -6.01627 +132 2 0.751389 1.61649 17.3659 4.93092 -7.13328 -12.7379 +133 1 18.2443 4.33431 15.8699 4.87602 -2.4936 -15.9817 +134 2 17.8369 3.63124 15.3424 2.32992 6.4949 4.25729 +135 2 0.452078 4.51482 15.4394 -9.42811 -2.49011 8.2103 +136 1 12.0529 17.1173 16.1421 -28.5646 -13.5401 15.8604 +137 2 11.3287 16.6705 16.6559 24.6179 11.2855 -13.6919 +138 2 11.708 17.1501 15.239 10.7504 0.848438 1.34073 +139 1 16.0751 2.69533 18.2299 -16.8426 22.7601 -19.9608 +140 2 15.7518 3.52741 18.6545 8.16925 -19.768 -14.2608 +141 2 15.768 2.75869 17.2894 6.47211 -5.43997 24.4047 +142 1 6.70105 13.7211 10.0493 -2.92253 -3.29615 13.924 +143 2 6.49616 13.3451 10.9223 2.46715 2.87816 -3.90822 +144 2 6.5701 13.0016 9.42848 5.58743 -2.71244 -4.10916 +145 1 10.1642 18.4563 2.66846 -6.4553 9.35236 -16.0973 +146 2 10.4494 0.522706 2.05557 -0.598662 -14.7868 7.93587 +147 2 9.23943 18.2921 2.43567 5.35466 0.524311 4.08806 +148 1 3.08905 17.6286 6.23363 28.1073 -1.15148 23.9606 +149 2 2.19758 17.5876 5.91536 -10.6529 4.22104 -18.8026 +150 2 3.7136 17.7221 5.50184 -12.297 -3.14114 -7.6924 +151 1 12.6187 16.7784 7.83399 -8.24743 2.38577 1.37984 +152 2 11.9273 16.0794 7.74003 7.37944 21.7069 5.85683 +153 2 12.3535 17.4638 8.48865 -0.622135 -17.7991 -6.24189 +154 1 14.8741 15.2807 8.33754 11.6667 3.93031 -5.87838 +155 2 14.2607 15.9458 8.0029 -4.6938 -2.09697 8.01324 +156 2 15.5465 15.2244 7.63778 -8.32879 0.363275 5.25782 +157 1 17.8358 18.3077 0.207666 -46.6557 3.82667 -12.4063 +158 2 18.5381 17.6928 0.20107 34.3258 -19.0599 -1.41311 +159 2 18.1099 0.429917 0.68066 12.6369 19.0779 11.4558 +160 1 0.768971 10.519 1.45234 -14.3967 -19.3664 19.1268 +161 2 -0.0407552 10.0454 1.78172 23.5075 9.70284 -14.2764 +162 2 0.503185 11.1892 0.827858 -7.10365 8.12718 -9.46819 +163 1 1.82037 12.3064 3.2607 -0.411525 2.12628 17.6018 +164 2 1.36119 11.682 2.70611 -2.67447 -10.2614 -7.1426 +165 2 2.03731 13.0482 2.69872 0.079619 5.20365 -3.96737 +166 1 0.725717 17.3003 4.98992 32.4002 3.58468 -34.9181 +167 2 -0.000639544 17.8885 5.08952 -19.7566 14.3988 12.6832 +168 2 0.713313 16.5777 5.58791 -15.4184 -21.9192 25.4801 +169 1 0.951486 0.797441 9.37101 14.826 11.188 -16.0996 +170 2 1.14791 0.588384 10.2838 -3.41112 -8.44303 11.2353 +171 2 0.0745467 0.497625 9.13864 -8.88294 -4.64793 9.22513 +172 1 16.8073 2.38946 13.4769 5.39787 -10.4284 -8.99471 +173 2 17.0506 2.69304 12.5747 -8.0967 -7.05722 13.8788 +174 2 16.5161 1.45381 13.4188 4.66162 13.0486 -2.08534 +175 1 2.62912 16.0502 12.0784 8.40953 -12.472 -10.7904 +176 2 3.04385 15.7269 12.8881 -2.37218 0.184289 -5.79457 +177 2 3.10949 15.6337 11.3228 -8.7582 6.42497 16.6586 +178 1 16.3457 15.4302 6.12389 30.9011 24.8554 -18.1041 +179 2 17.2992 15.5349 6.36757 -22.0844 -7.23183 -0.993592 +180 2 16.19 16.1865 5.50068 -1.85714 -20.6143 14.9819 +181 1 5.77873 5.21745 11.785 11.0193 -20.9315 -11.6683 +182 2 5.50793 5.92484 12.3546 -4.36629 16.5013 7.19057 +183 2 5.27867 4.45162 12.0794 -6.37659 -1.59945 -1.70387 +184 1 15.1747 4.94504 0.761547 -29.5175 -4.13494 28.6724 +185 2 14.9952 4.57194 1.67189 6.69018 16.901 -24.5633 +186 2 14.3176 5.30548 0.449447 18.0211 -8.94221 4.63226 +187 1 16.4144 16.461 1.77501 8.34865 -5.69196 -8.65308 +188 2 16.356 16.7636 2.67626 -8.71628 3.92983 13.8981 +189 2 16.7832 17.2073 1.29403 -0.614878 1.7319 -3.63708 +190 1 0.136057 4.8659 3.98965 34.6037 22.2365 -2.60366 +191 2 0.554963 5.79058 3.9624 -19.788 -38.6093 6.27627 +192 2 0.840291 4.21253 4.20207 -10.6708 20.7839 -4.14843 +193 1 2.91044 15.0804 15.1041 7.34684 -10.5058 14.2682 +194 2 2.90482 14.7198 16.034 -7.41786 16.0657 -24.8201 +195 2 2.46761 15.9418 15.099 -2.49045 -2.68752 9.6724 +196 1 0.98952 14.6361 9.40184 3.41519 -3.90395 6.55514 +197 2 1.54705 13.945 9.00075 -6.08548 3.23571 10.1521 +198 2 0.78947 14.3674 10.3125 0.535168 -4.82993 -11.1122 +199 1 13.5676 16.5089 11.5672 -19.673 9.58551 -20.9583 +200 2 13.2883 17.2623 10.9814 5.35041 -18.2182 15.9177 +201 2 13.0352 15.7491 11.2513 9.15027 7.77217 2.32965 +202 1 4.84709 1.60354 0.665871 -13.2454 -7.94988 -14.2061 +203 2 4.37724 2.10746 -0.0295305 4.1335 -5.07179 15.4313 +204 2 4.23428 0.890311 0.93575 7.29231 10.3056 3.49355 +205 1 1.57562 18.6232 11.9448 -9.54215 3.4719 -19.1533 +206 2 1.53947 0.452662 12.7669 0.622104 8.67092 13.3018 +207 2 1.94164 17.7639 12.1401 7.67295 -5.68018 1.31967 +208 1 11.3828 10.0809 4.23132 25.5406 -0.783734 -33.5194 +209 2 11.2477 10.3841 3.29047 7.40472 -5.62792 30.1478 +210 2 12.3604 9.90108 4.31318 -36.068 9.82931 1.34024 +211 1 8.1924 12.225 3.79726 -5.69748 14.5101 56.1678 +212 2 9.05523 12.5573 4.13122 -12.2475 -6.42112 -18.1901 +213 2 7.61811 12.3317 4.63279 18.664 -10.6547 -44.172 +214 1 14.6446 4.04033 3.3856 3.29585 4.20735 14.8065 +215 2 15.1799 4.13354 4.21231 -10.8641 -1.34483 -21.0767 +216 2 13.7289 4.27483 3.60977 8.83721 -0.102893 1.13309 +217 1 5.73789 1.70847 7.633 -45.2268 -33.2589 19.0394 +218 2 5.00558 1.12579 8.07813 40.2552 34.7696 -21.6936 +219 2 5.52319 1.67762 6.69069 2.06189 0.609235 -2.30714 +220 1 17.8554 0.94247 4.83325 2.84508 1.94772 -6.32822 +221 2 18.4375 1.13729 4.06994 -6.68522 3.20321 14.3473 +222 2 17.8361 1.70281 5.4359 2.52705 -5.98387 -7.60558 +223 1 6.82607 9.13014 4.53731 -2.03949 -2.27606 -0.824268 +224 2 6.749 9.37751 5.45829 -4.27203 4.05265 7.19029 +225 2 7.76352 8.95198 4.44117 4.86868 -1.78157 -6.05796 +226 1 2.39805 14.6397 2.05874 17.0918 -1.49078 4.46086 +227 2 3.17145 14.6314 2.66377 -10.8679 0.525641 -12.6634 +228 2 2.72903 14.4183 1.17543 -1.81421 4.03234 5.90777 +229 1 17.1796 12.9575 13.0281 -10.0626 2.91445 0.0973403 +230 2 16.3048 13.3397 13.2675 20.7192 2.62525 -4.36947 +231 2 17.7682 13.6617 12.6978 -15.1419 2.46765 5.43564 +232 1 14.7925 10.5715 1.51204 -8.6843 -36.4521 -19.1925 +233 2 15.3686 11.2103 1.85793 27.186 33.4644 17.5702 +234 2 13.9217 10.9161 1.62765 -18.2001 7.18743 0.677482 +235 1 5.63756 6.65584 4.53835 -5.70194 -14.7917 8.95129 +236 2 5.96892 7.55557 4.50237 4.06113 5.5935 -1.33512 +237 2 6.19689 6.19506 5.18786 2.48768 6.43185 -8.34619 +238 1 8.1035 8.32015 10.3633 -6.06951 -1.51391 13.5103 +239 2 8.71051 8.88696 9.88772 3.75134 6.39998 -5.242 +240 2 7.4427 8.01108 9.7382 -0.891776 -1.59521 -4.95879 +241 1 13.4554 18.4382 5.64567 -23.0826 -2.6609 26.3697 +242 2 12.6541 0.350227 5.51512 12.1971 -9.37205 -2.29397 +243 2 13.2308 17.8847 6.43702 5.12544 9.06169 -21.995 +244 1 0.0481459 2.53289 0.450073 0.762545 20.3906 -8.36614 +245 2 17.7393 2.57826 18.829 23.3906 9.65711 1.86789 +246 2 0.50996 3.41343 0.303855 -21.6669 -27.8541 1.68488 +247 1 12.9745 10.8048 9.65469 -32.5048 41.5261 -13.285 +248 2 12.0083 11.0976 9.65119 33.8953 -25.1931 3.11551 +249 2 13.0333 9.87229 9.85209 -8.8072 -6.07099 4.09073 +250 1 0.527116 12.3319 11.2575 10.4347 -0.622496 2.4881 +251 2 18.2313 12.2915 11.4294 -10.2968 -1.46033 -6.74513 +252 2 0.909084 12.5363 12.117 7.12796 0.366826 -3.41572 +253 1 5.28415 7.34725 13.2845 -6.32664 2.65038 2.55184 +254 2 5.64713 8.17412 12.9655 4.82658 4.12789 -9.57053 +255 2 5.74627 7.2293 14.1116 0.316635 -7.58532 9.69513 +256 1 1.16454 6.74183 12.03 -13.1625 -42.3004 -9.02199 +257 2 0.295417 6.98712 11.7254 -9.09418 5.46945 -3.0829 +258 2 1.57891 7.53521 12.2772 19.8541 36.5775 12.6901 +259 1 15.5783 9.75012 12.4577 9.71681 16.8235 16.5595 +260 2 15.2431 10.6351 12.2158 0.950441 -15.6258 3.07953 +261 2 16.0853 9.89705 13.2804 -12.0519 -4.92211 -13.1427 +262 1 16.5993 12.6285 5.60521 -10.2494 37.6021 -45.7262 +263 2 16.4242 13.6113 5.62967 5.67224 -29.3823 14.3376 +264 2 16.441 12.4706 4.63081 7.92181 -5.25591 31.2114 +265 1 6.41284 9.90681 0.119653 0.515871 -10.7086 -9.9123 +266 2 5.64934 10.3727 0.465056 -3.06655 2.33505 3.46562 +267 2 7.14462 10.1266 0.702846 2.16363 1.41956 4.36049 +268 1 12.2095 5.93838 4.00309 -11.5544 -2.90268 -3.08172 +269 2 12.2942 6.66752 3.37735 2.08742 0.382808 1.33145 +270 2 11.2587 5.74648 4.01779 6.74513 0.670066 1.17813 +271 1 0.342924 12.9268 0.00967172 -2.71894 -2.13654 5.95194 +272 2 18.7348 13.4393 0.793746 3.88983 0.588143 -5.53597 +273 2 18.4589 13.2921 17.9296 1.41778 -5.28425 5.34754 +274 1 3.57599 18.7244 8.67011 -7.57313 7.8026 -17.3863 +275 2 3.53053 18.3214 7.79351 4.94999 -5.98969 2.51912 +276 2 2.6975 0.472694 8.72681 1.72246 -0.921876 11.7862 +277 1 7.19816 17.4543 4.42938 13.0422 27.6578 -13.842 +278 2 7.51541 18.3714 4.6455 -6.70989 -26.1973 -6.43912 +279 2 7.34255 17.3635 3.4592 -3.95356 0.0926602 20.0901 +280 1 9.24276 17.181 12.1874 27.1924 -9.91753 -12.8104 +281 2 9.16544 16.536 11.4403 4.06483 10.4089 22.9332 +282 2 10.1989 17.1789 12.4847 -33.3611 -0.423317 -5.22003 +283 1 13.2427 13.2324 7.99028 -4.63127 -11.2433 10.7708 +284 2 13.2975 12.5097 8.63573 0.309708 1.2863 -7.28868 +285 2 13.9184 13.8596 8.25103 7.01778 4.96536 -0.211076 +286 1 14.7706 2.86972 15.5058 12.3246 -20.976 -18.3849 +287 2 14.0341 2.28041 15.2496 10.8751 5.18171 6.07562 +288 2 15.4548 2.72916 14.8136 -15.3015 9.06101 10.4071 +289 1 9.96013 15.6554 16.9624 -0.416257 -4.3558 -3.6035 +290 2 10.3061 14.8055 16.6414 -1.75696 6.53817 2.71112 +291 2 9.61308 15.4752 17.8389 -3.07369 -3.40172 1.73448 +292 1 11.2206 8.54091 16.6271 11.2119 0.246209 -0.153837 +293 2 10.3853 8.13843 16.425 -12.7378 -7.75768 -8.20822 +294 2 11.7159 7.85532 17.0695 3.92811 -4.5145 7.83184 +295 1 4.19128 18.3534 16.7936 -2.0541 -15.6573 2.75359 +296 2 4.49896 17.6946 17.4386 1.3239 2.14246 -6.87061 +297 2 4.3476 0.553135 17.2025 -0.294224 9.43754 2.6314 +298 1 2.38271 4.321 8.90759 20.0465 -16.3105 29.2362 +299 2 3.33364 4.03277 8.87737 -27.5446 13.4253 -3.78204 +300 2 2.08958 4.1083 9.83354 7.71669 6.29647 -26.7475 +301 1 9.9842 10.4369 9.88352 -17.0195 21.6351 -0.0387615 +302 2 9.44133 11.1731 9.47934 17.4922 -21.0458 18.4718 +303 2 9.94225 10.4854 10.8652 2.27572 1.94662 -18.6097 +304 1 9.85899 0.920399 10.8075 0.162278 -2.63975 1.09763 +305 2 9.48302 0.0750215 11.0855 -2.58178 2.3482 3.77053 +306 2 9.21377 1.33985 10.2254 -0.0206645 -1.54215 -2.59695 +307 1 9.16055 15.229 10.2075 -19.4407 -6.65372 -14.862 +308 2 8.92137 15.8821 9.51239 -0.317996 -13.1788 14.0466 +309 2 8.43697 14.5477 10.1944 18.1534 21.6077 -0.815821 +310 1 0.71674 9.75329 10.1461 2.10813 23.2969 8.50765 +311 2 0.819344 10.7283 10.3167 -3.94998 -28.3852 -4.44668 +312 2 1.15296 9.53542 9.32246 0.728257 4.55427 -3.87479 +313 1 17.2456 4.88922 8.01698 -15.6269 -0.477795 25.7007 +314 2 16.4423 5.19943 8.52213 28.7194 -9.29348 -15.89 +315 2 17.7804 4.31587 8.60398 -15.5446 9.64156 -7.98894 +316 1 14.822 14.6129 0.044879 1.26259 -7.26488 27.1569 +317 2 15.5503 14.8635 0.654609 -16.5042 1.70925 -13.2775 +318 2 14.1019 14.3181 0.644441 11.2495 5.19015 -13.4399 +319 1 3.93398 11.151 9.56657 -13.0999 1.1143 6.92396 +320 2 3.8819 11.1389 10.5379 -0.108421 8.58768 -6.25849 +321 2 3.2885 11.8101 9.24754 8.95434 -7.44407 0.420275 +322 1 11.481 10.7372 1.49136 -12.2308 11.5287 -6.19882 +323 2 11.6479 11.6347 1.11375 -3.03535 -20.3842 8.82813 +324 2 10.5208 10.5745 1.38561 13.1816 3.92224 -1.496 +325 1 13.1382 7.21836 12.5396 -14.3564 7.08975 0.177427 +326 2 14.0771 7.12045 12.4061 13.875 -7.92794 3.07029 +327 2 12.7619 6.3345 12.5945 1.25366 -4.42296 3.81153 +328 1 9.68698 1.99848 0.824055 10.3256 0.727137 24.2023 +329 2 8.81917 1.78721 0.50968 -15.0497 -1.62599 -5.65 +330 2 10.155 2.38703 0.0980655 8.32187 5.69202 -13.7925 +331 1 10.602 13.3929 4.55586 17.4753 0.473987 25.0493 +332 2 11.4671 12.9458 4.66597 -13.9744 4.33191 -5.6004 +333 2 10.4831 13.8198 5.42698 -1.33045 -1.26907 -13.5894 +334 1 14.5505 1.55995 10.9504 0.793491 3.39408 -6.18689 +335 2 15.3506 1.17936 10.5364 -11.0229 12.1378 4.59402 +336 2 14.5582 2.53024 10.8225 7.4254 -12.0179 1.55597 +337 1 14.4508 12.0407 11.6074 10.4267 -5.99888 -36.1251 +338 2 15.2905 12.2256 11.0848 -31.5625 -1.98982 15.431 +339 2 13.8033 11.6041 10.9773 26.0423 16.8772 21.3357 +340 1 8.16091 5.15464 9.81808 -31.1733 -3.04727 19.1057 +341 2 7.28259 5.21015 10.2725 23.9466 4.77499 -10.0641 +342 2 8.23945 4.21356 9.63446 4.25293 -1.90524 -4.29988 +343 1 1.57078 16.9857 18.5145 2.11582 4.65495 -1.34384 +344 2 1.81738 17.3492 17.6562 0.32294 -2.46744 1.69741 +345 2 1.87051 16.0745 18.5076 0.982883 -4.60963 -1.80737 +346 1 1.40224 17.4231 15.3612 30.835 -28.8708 -16.9337 +347 2 1.58171 18.2262 15.8024 1.01568 35.607 16.5514 +348 2 0.474852 17.284 15.3634 -28.8421 -6.17683 0.802216 +349 1 3.44554 5.70547 6.04619 4.62282 22.475 -0.524537 +350 2 3.1428 6.44974 6.61309 0.90031 -17.6364 -10.4242 +351 2 4.06586 6.09018 5.39907 -5.11167 -0.757253 7.03456 +352 1 12.635 9.5385 14.2471 10.4135 -57.691 -2.75625 +353 2 13.0561 8.75521 13.7543 -17.7171 41.3381 15.7803 +354 2 12.3533 9.10151 15.082 0.88858 17.3566 -13.7461 +355 1 4.11217 15.1814 7.19429 24.0597 14.9458 -6.20919 +356 2 3.65166 15.9525 6.80506 8.00815 -8.18076 7.53786 +357 2 5.09537 15.3539 7.08579 -34.9804 -3.92885 1.78443 +358 1 0.830872 8.84313 15.1657 1.50937 4.0339 -6.81168 +359 2 0.547306 9.77972 15.0966 9.11455 -14.6477 -1.64448 +360 2 1.6109 8.72602 14.589 -11.0561 6.95599 3.23137 +361 1 12.8981 8.26079 10.0923 10.5692 -21.7103 -4.02448 +362 2 13.6229 7.70102 9.77244 -0.136865 10.7899 -7.02632 +363 2 12.7945 7.93077 10.9815 -6.52785 3.68747 11.7154 +364 1 15.1981 8.09018 3.38532 -13.0459 -52.6521 2.11346 +365 2 14.5247 7.61376 2.86907 3.36606 26.685 -8.7616 +366 2 15.3386 7.39586 4.05885 15.5852 26.7124 4.01456 +367 1 17.1365 6.7605 0.0284285 -19.4133 2.32297 -2.08842 +368 2 16.6422 5.96523 0.300426 11.1165 9.80228 -2.81184 +369 2 16.4267 7.37993 18.3943 16.5678 -7.00446 5.84521 +370 1 8.97527 7.00353 7.90402 -12.8517 -1.3564 7.9131 +371 2 9.8962 7.25242 7.83012 8.98921 2.98997 4.36252 +372 2 8.82463 6.62979 8.79874 5.5237 0.780274 -18.1173 +373 1 12.5342 0.599732 1.22272 7.37234 -11.2249 5.10795 +374 2 13.3221 0.863275 1.71742 -3.27048 6.46822 -3.34517 +375 2 12.885 0.18837 0.429335 -4.8121 3.35952 -2.50919 +376 1 5.70486 15.0289 14.4325 -10.0966 26.0987 -8.04315 +377 2 4.75654 15.1126 14.6498 8.83064 -2.51751 -1.0487 +378 2 5.99172 15.9344 14.1552 -2.67099 -19.6319 8.34541 +379 1 3.68772 6.51886 1.67786 -9.02664 17.532 -4.1283 +380 2 3.3123 7.35563 1.32777 6.95322 -18.4916 -0.718273 +381 2 3.69933 6.70385 2.62114 4.49099 -5.2411 1.79351 +382 1 3.84119 11.2683 12.301 -11.0219 1.87445 3.30422 +383 2 4.7083 11.6207 12.5295 0.62865 1.71432 1.43021 +384 2 3.16952 11.829 12.7259 9.18863 0.324364 -2.3982 +385 1 5.33774 3.90131 15.6575 3.88008 58.1131 -0.302695 +386 2 6.0029 3.30263 15.356 18.6017 -19.7261 -0.90724 +387 2 5.77609 4.81808 15.6348 -20.8077 -39.2998 1.51453 +388 1 13.9476 10.0954 4.76119 43.1598 -13.631 -14.8551 +389 2 14.3099 9.89525 5.64952 -11.5358 -2.78357 -16.2598 +390 2 14.5437 9.62633 4.09138 -26.3956 16.5702 30.5617 +391 1 7.47949 17.2779 8.9575 1.27559 12.2273 10.3752 +392 2 6.80648 17.541 9.63427 13.3482 -0.885269 -20.4433 +393 2 7.81637 18.0666 8.4826 -8.0179 -7.75644 7.92076 +394 1 4.60365 14.3557 3.73459 -2.67085 -0.0597314 40.4087 +395 2 4.53549 15.2621 4.14744 4.43815 -28.6634 -11.7113 +396 2 4.62044 13.6529 4.46513 -1.80956 31.3212 -27.6241 +397 1 14.2431 7.29194 15.9057 25.6353 16.9765 2.1683 +398 2 15.0475 7.32515 15.3368 -17.0197 -3.00413 14.2387 +399 2 14.4656 7.87429 16.6673 -6.53416 -15.6271 -13.0076 +400 1 2.96496 18.4208 1.99119 15.7852 32.1682 20.7835 +401 2 2.67672 17.8955 1.28044 -15.5564 -27.5435 -28.9446 +402 2 2.23493 0.385121 2.17733 5.2916 -3.96739 2.45348 +403 1 7.98476 1.5873 4.50407 1.38949 2.52923 0.695279 +404 2 7.37343 2.0449 3.91068 5.19751 -1.80104 2.00097 +405 2 8.86519 1.9238 4.29038 -5.22298 -3.29695 -0.501883 +406 1 2.57117 14.1691 17.7571 1.007 -17.2424 4.53378 +407 2 1.90219 13.4698 17.9606 14.5878 19.4169 -2.4542 +408 2 3.44824 13.7555 17.8862 -10.6426 1.83574 2.42644 +409 1 1.00451 2.03285 13.8784 10.3502 2.39599 -10.3714 +410 2 1.16144 1.84563 14.7992 2.97823 -2.88805 14.0985 +411 2 0.0700994 1.90667 13.7535 -13.5508 1.82952 -2.05389 +412 1 4.33902 0.200757 13.8843 13.0721 -10.005 -1.30306 +413 2 5.22858 18.4296 13.858 -15.0619 9.43809 1.75921 +414 2 3.93054 18.5168 14.6942 4.28146 4.19272 1.73225 +415 1 7.39543 1.05973 18.4904 -6.66444 -3.84456 4.72925 +416 2 7.66739 0.634389 17.6825 2.48525 -3.87431 -15.5197 +417 2 6.44311 1.20989 18.4324 3.08246 -0.882049 5.31666 +418 1 15.7652 18.4035 13.928 -3.86344 6.1861 11.5309 +419 2 14.8535 18.6979 13.7607 9.26883 -6.83338 6.65234 +420 2 15.8985 -0.310566 14.8997 -7.7909 7.80446 -17.2978 +421 1 10.2952 4.64795 16.1844 -42.7729 -17.7833 -2.18791 +422 2 11.2045 4.84382 16.2798 37.5776 1.06228 1.58962 +423 2 10.2217 3.67206 16.1998 1.46017 15.0252 -2.22652 +424 1 15.8927 17.6472 4.46477 -15.4234 23.5431 17.5975 +425 2 16.4754 18.4255 4.65687 -16.3789 -18.5079 -6.3799 +426 2 14.9773 17.9018 4.78742 33.6258 -6.52099 -13.8394 +427 1 6.90155 17.6195 13.966 46.0362 -18.082 7.69792 +428 2 7.5054 17.5909 14.7751 -24.8486 6.04139 -28.3759 +429 2 7.50943 17.3755 13.214 -16.8133 11.713 21.5591 +430 1 13.2082 6.37265 6.52765 -13.548 -6.29238 7.5029 +431 2 14.0171 6.83631 6.34759 17.8515 4.0742 0.884882 +432 2 12.7912 6.26458 5.66961 -1.80962 -1.49443 -3.94736 +433 1 7.85263 2.26509 9.52735 -7.99894 -5.84405 -22.7054 +434 2 7.25184 2.06178 10.2504 -3.996 2.15095 3.09306 +435 2 7.39499 1.97805 8.69805 10.2818 7.88442 20.3126 +436 1 15.1135 14.8377 13.7906 -14.0873 7.85215 4.54273 +437 2 14.8065 15.1503 14.6696 4.89633 -5.66092 -15.9193 +438 2 14.526 15.2486 13.1323 8.68819 -2.70507 8.56313 +439 1 9.34389 8.42481 3.82801 17.2784 -12.6228 -3.36469 +440 2 10.2481 8.71643 4.0808 -19.781 -0.493733 -4.13474 +441 2 9.39514 7.45876 3.71283 -1.01674 10.6173 4.41109 +442 1 17.6406 13.5721 16.5094 2.04355 14.6677 -13.2606 +443 2 16.6957 13.3564 16.5004 3.03121 5.86868 -4.35941 +444 2 17.7908 14.3862 15.9732 -9.46726 -16.3028 8.56732 +445 1 4.98477 10.3524 2.78056 12.7386 5.36526 19.5004 +446 2 5.77841 9.87677 3.08402 -8.11584 2.70387 -5.95057 +447 2 4.78102 10.9105 3.55814 -3.18863 -4.34789 -14.1468 +448 1 3.61985 8.409 9.90418 -6.90754 6.83907 7.996 +449 2 3.65115 9.35813 9.71914 3.08439 -3.40065 -3.71786 +450 2 3.2182 8.36489 10.7858 3.70965 -2.47637 -5.74153 +451 1 15.9601 6.9243 5.80742 5.84252 7.06727 3.15212 +452 2 16.6786 7.33659 6.3256 -10.6597 -9.43019 -8.8571 +453 2 16.2068 5.99858 5.66915 1.21675 5.97088 2.68601 +454 1 15.2845 7.30815 8.96614 12.789 49.367 -12.5087 +455 2 15.9618 7.62249 9.60336 -10.429 -10.3168 -7.48119 +456 2 15.189 8.09577 8.33246 -3.07462 -40.144 23.8491 +457 1 6.1828 12.7537 12.7561 7.28509 13.2747 4.63662 +458 2 7.05451 12.4627 13.0861 -13.4204 -0.208789 -0.140696 +459 2 5.95622 13.5898 13.2147 8.13015 -13.1574 -2.88232 +460 1 12.1263 4.55994 13.1396 29.7192 24.8274 2.05513 +461 2 12.1786 4.68706 14.0984 -0.0287765 -3.56256 -2.83377 +462 2 11.367 4.05454 12.9285 -29.3831 -17.3036 -0.987503 +463 1 11.4694 8.07241 7.80966 2.82892 -5.30182 3.11258 +464 2 12.1089 7.42736 7.43222 -7.16455 14.3649 9.80055 +465 2 11.7078 8.26067 8.74179 3.19872 -8.99269 -16.594 +466 1 16.9463 10.7531 7.60486 21.0922 -19.3927 -30.7185 +467 2 17.5464 10.0071 7.31859 -16.0594 21.8542 15.0855 +468 2 16.9098 11.3402 6.82058 -3.06841 -4.58473 14.7168 +469 1 5.28146 18.0409 10.6472 -25.9515 -7.83546 -6.26387 +470 2 4.85268 17.2439 11.0337 11.609 18.382 -10.1496 +471 2 4.62194 18.3715 9.98111 20.3861 -11.8767 18.8687 +472 1 7.65293 17.466 1.56177 -3.43219 -2.17163 16.4468 +473 2 8.27069 16.8213 1.23778 3.23069 -17.6415 -5.16563 +474 2 7.58305 18.0963 0.859771 -3.72786 20.9018 -9.77855 +475 1 1.92587 12.9087 13.6164 -8.16731 5.11551 18.4441 +476 2 1.30634 12.3949 14.1755 13.4846 7.44573 -7.00244 +477 2 2.13079 13.7319 14.1159 -1.95883 -16.9131 -9.84331 +478 1 9.29336 6.75339 14.7687 -19.1125 21.7104 1.76678 +479 2 9.711 5.9819 15.1082 15.9481 -24.452 8.13362 +480 2 9.58853 6.88119 13.8676 2.75751 0.822828 -8.36077 +481 1 15.2452 4.28737 10.7623 -0.225576 -4.08648 -1.74219 +482 2 16.1503 3.99339 10.8719 6.1947 -5.72264 -8.71474 +483 2 15.1717 4.92602 11.4736 -7.0877 3.5816 0.665059 +484 1 11.4391 6.24473 0.0517087 -15.4849 -28.4826 -7.88372 +485 2 11.5335 5.29025 18.4586 5.11122 21.8085 5.83846 +486 2 10.469 6.36117 18.7264 13.3105 4.99187 -1.92993 +487 1 18.4571 11.4845 14.9094 -8.14212 27.2991 -26.8701 +488 2 18.0442 12.0056 14.1458 10.7134 -26.1217 30.6713 +489 2 18.3691 12.0954 15.6567 -1.55188 -2.54901 -1.51407 +490 1 7.07006 9.2713 7.35429 3.52198 -23.4346 -4.90088 +491 2 6.57918 8.46088 7.59869 6.01934 15.522 -0.341791 +492 2 7.98054 8.95273 7.2441 -4.91945 6.78887 2.19469 +493 1 18.4213 15.3485 12.1512 14.6289 14.7183 -5.00343 +494 2 0.703338 15.6554 12.0361 -12.928 -5.55139 4.18882 +495 2 17.8805 15.9633 11.6295 -1.60931 -6.92771 2.64168 +496 1 16.5853 4.3259 5.32941 -3.23822 -14.2219 46.7572 +497 2 16.614 4.15863 6.32722 1.43031 7.89007 -40.0485 +498 2 17.5031 4.43236 5.0545 -4.12857 4.88068 -4.00684 +499 1 17.7656 3.15988 10.7489 -7.77815 -3.54726 5.22618 +500 2 18.6517 3.33727 11.1036 -6.02481 -6.41431 -8.69585 +501 2 17.7347 2.25304 10.4054 5.10772 5.83768 0.491016 +502 1 12.3532 18.6195 10.0845 2.26138 29.9542 0.82462 +503 2 11.4554 0.369133 10.2956 34.814 -7.7062 -6.49387 +504 2 13.0539 0.703372 10.1287 -31.4455 -25.8056 2.12568 +505 1 10.4062 9.7592 12.5463 4.94309 9.48659 9.1975 +506 2 11.1178 9.86775 13.2051 -4.84217 -3.21907 -8.75193 +507 2 10.4169 8.83 12.3092 -0.242296 -5.43122 1.67162 +508 1 0.754807 2.57366 7.2759 5.10959 9.37805 -1.17349 +509 2 1.15147 3.40426 7.59563 -2.53061 -11.14 3.70439 +510 2 0.94825 1.90755 7.95351 -0.370046 8.4477 -4.76995 +511 1 0.326852 15.3245 6.92393 7.78779 -47.7914 -15.9381 +512 2 0.478367 15.1955 7.87742 -3.54148 6.5065 -12.4551 +513 2 0.511792 14.4078 6.50445 -6.22026 47.2618 21.2659 +514 1 17.0448 6.87527 14.9011 7.50868 -3.64469 2.18783 +515 2 17.7829 7.50382 14.839 -4.82102 -5.02166 1.59119 +516 2 17.384 6.09018 15.3732 -3.19441 8.7454 -5.86774 +517 1 9.10521 12.4991 8.01627 -22.444 -7.37457 -9.07321 +518 2 9.5155 11.7197 7.59468 -6.97176 5.64777 -5.01838 +519 2 8.17012 12.5725 7.67989 31.3303 -7.17656 9.91942 +520 1 1.12679 1.65794 2.79756 -4.95635 8.46302 6.6874 +521 2 0.642552 2.15227 2.11219 8.6081 -1.07022 6.53976 +522 2 1.60228 2.28223 3.37541 -5.16033 -3.32404 -9.46208 +523 1 4.24509 15.0269 10.0531 -9.28044 4.63084 -2.70058 +524 2 3.93721 15.2031 9.15401 2.26907 2.00751 2.33164 +525 2 5.07496 14.5648 9.92961 6.13338 0.348707 3.17177 +526 1 7.39613 2.22212 14.8791 -10.1428 -2.73186 -2.62368 +527 2 7.12857 1.59843 14.1951 -0.211704 -1.85534 3.14611 +528 2 7.6308 3.01777 14.3992 6.19568 3.75469 -5.36272 +529 1 18.3005 14.5161 2.14907 5.30067 -9.26209 1.4902 +530 2 0.506128 14.8057 2.49377 4.6744 -0.083839 -4.04908 +531 2 17.8019 15.308 1.97101 -9.85855 11.1774 -0.48774 +532 1 10.0782 2.71092 12.8944 3.88974 -3.73664 -2.78909 +533 2 9.88925 2.05355 12.2072 4.3936 3.86452 2.74403 +534 2 9.31937 3.3006 12.9074 -3.94823 0.261307 -1.05017 +535 1 2.9306 8.79131 12.9512 -25.6961 -20.8645 -0.44372 +536 2 3.33593 9.62792 12.788 10.417 21.0465 -4.83397 +537 2 3.64632 8.1716 13.058 11.1871 -7.80414 6.67576 +538 1 3.17851 8.59155 3.78391 36.0219 9.48042 20.5594 +539 2 3.64638 9.17092 3.16182 -4.0064 -4.18597 2.27442 +540 2 3.67104 8.74964 4.63715 -24.9674 -6.25544 -24.3579 +541 1 5.79667 7.27872 8.61723 -5.158 -8.45889 2.36629 +542 2 5.76122 6.32524 8.453 -1.10357 3.40671 2.32671 +543 2 5.00318 7.4879 9.12925 4.38374 0.567505 0.838777 +544 1 14.9116 1.65307 1.84567 7.03031 -5.18946 -10.6018 +545 2 15.1062 2.45757 2.3139 -4.94852 6.93451 15.0643 +546 2 15.1691 1.84916 0.935056 -0.310542 -6.30296 3.0909 +547 1 8.67523 15.0369 0.613894 1.37845 1.1536 3.61737 +548 2 9.43682 15.0729 1.21213 -3.42809 -6.51916 3.89646 +549 2 8.00447 14.4711 1.03609 4.49017 7.63347 -1.72767 +550 1 15.3993 1.47022 7.19229 -20.8703 -2.58026 0.276614 +551 2 14.6837 0.967989 6.72584 19.4319 15.0033 11.4079 +552 2 14.9834 2.26826 7.5843 2.60239 -12.333 -11.18 +553 1 4.89704 12.855 18.4725 17.7474 3.66438 12.0852 +554 2 5.22521 13.0209 0.739851 -5.30909 -3.44768 -15.7686 +555 2 5.64886 13.1114 17.9131 -8.88833 1.88365 4.35483 +556 1 15.3966 8.71526 18.0579 -0.0737912 10.217 -6.92241 +557 2 15.7913 9.20885 17.3059 -4.72516 -6.1114 19.2356 +558 2 15.2466 9.35419 0.13361 -0.210218 -4.05252 -7.18588 +559 1 11.9654 3.16879 18.3684 -1.96391 -6.33771 9.57431 +560 2 11.8782 2.93896 0.667559 5.83177 -2.01678 -11.7343 +561 2 12.3624 2.38725 17.9444 -0.743858 8.0566 3.61175 +562 1 13.1976 12.733 5.19814 3.21154 2.81721 -3.88454 +563 2 13.6265 11.8743 5.11099 -2.80289 -1.59076 -2.45209 +564 2 13.3962 13.0406 6.08845 -1.48061 -3.43823 1.63358 +565 1 6.20234 7.07161 0.291392 8.37087 -8.50913 -15.2358 +566 2 6.21431 8.03007 18.9132 -3.08565 9.14852 3.50692 +567 2 5.28911 6.79756 0.384068 -8.05152 4.04277 7.5169 +568 1 17.755 15.8811 14.8809 -0.846783 4.67036 -1.95176 +569 2 16.8205 16.1356 14.922 6.46156 -5.25763 -8.70949 +570 2 17.9775 15.7319 13.9423 -7.01069 1.37948 9.8425 +571 1 13.0816 0.927432 16.7559 7.19813 -13.1533 1.9849 +572 2 14.0246 0.654652 16.7787 -14.5584 8.9122 1.46691 +573 2 12.5958 0.0867106 16.6751 4.09548 8.26383 -2.86333 +574 1 10.8721 14.5032 7.42074 17.8947 27.9436 -17.0444 +575 2 10.196 13.9242 7.71676 -22.829 -18.2345 11.9548 +576 2 11.6972 14.0514 7.58445 7.42519 -9.80791 -0.577526 +577 1 17.7647 8.42346 2.16939 -4.1598 1.60766 -5.89387 +578 2 16.8709 8.3975 2.49669 -12.234 5.23478 11.868 +579 2 17.7295 7.75318 1.48744 5.54579 -3.65645 -10.0136 +580 1 12.5773 7.79072 2.0332 1.0668 2.49746 -6.2566 +581 2 12.3914 8.73063 1.87761 -0.101344 -7.79782 -0.82295 +582 2 12.2276 7.2965 1.27263 1.31444 5.98607 5.5368 +583 1 12.0208 14.4615 10.4933 -27.7219 6.00234 -17.9899 +584 2 12.3406 14.2687 9.58404 -10.0812 4.98999 20.4987 +585 2 11.0483 14.7039 10.4238 33.6221 -8.97773 -1.58279 +586 1 6.69486 6.68845 15.5484 18.1135 9.98152 11.3143 +587 2 7.65688 6.85274 15.3559 -27.8703 -4.06425 5.81014 +588 2 6.48582 7.17335 16.3722 6.10572 -10.2019 -13.6564 +589 1 7.96659 4.39718 13.2272 4.51058 -7.9075 4.77481 +590 2 7.2893 4.70584 12.6248 -6.54048 3.46732 -4.14994 +591 2 8.21018 5.15068 13.7582 2.30488 10.1178 3.17748 +592 1 13.2671 12.2369 14.4347 -4.64765 -4.51239 1.04229 +593 2 13.0608 11.2949 14.304 4.07546 7.63325 0.952283 +594 2 13.624 12.5445 13.5893 -0.484314 -1.81518 4.66288 +595 1 14.4631 9.64208 7.37348 -3.22195 -17.9745 -8.46037 +596 2 15.2455 10.1455 7.54143 19.6931 12.3162 5.07411 +597 2 13.7594 10.075 7.84063 -11.2512 5.66435 9.63044 +598 1 12.6955 16.8004 3.38503 4.61351 40.5798 -15.2407 +599 2 12.79 17.4151 4.16128 -2.51333 -18.5745 -25.4999 +600 2 12.6728 17.373 2.55111 0.0132769 -17.6878 38.2975 +601 1 0.968812 6.96727 17.3326 -17.527 29.8281 -14.7856 +602 2 0.0966102 7.11435 17.7475 9.38145 -12.9539 -1.45746 +603 2 0.942675 7.56475 16.5473 6.51552 -11.7527 16.88 +604 1 12.9918 4.86088 15.7598 14.9884 1.53364 0.213735 +605 2 13.6417 4.12341 15.6561 -13.2544 27.5281 4.62454 +606 2 13.5036 5.69571 15.8607 -8.5455 -17.4296 -3.38108 +607 1 2.31456 3.41181 5.02375 -16.8072 14.5355 28.5245 +608 2 1.72499 3.01856 5.74541 26.0591 16.5367 -23.5498 +609 2 2.61813 4.33638 5.31016 -13.7452 -42.3935 -5.38282 +610 1 8.12877 10.8743 13.7813 26.8177 -26.1009 35.9685 +611 2 8.08888 10.4248 14.7095 5.12746 27.8083 -58.2879 +612 2 8.93477 10.511 13.3312 -19.2021 7.65314 13.0743 +613 1 13.0038 1.57226 13.2324 0.46489 2.31008 -10.6366 +614 2 13.6096 1.43937 12.4592 -18.9356 10.6634 16.2552 +615 2 12.412 2.34128 13.062 19.3329 -16.3736 -0.813643 +616 1 6.65189 13.7072 1.97939 -2.77776 -1.20266 13.9341 +617 2 6.01392 14.2112 2.53362 13.0928 -13.1372 -7.18637 +618 2 7.15166 13.1216 2.589 -8.8324 11.1791 -7.86511 +619 1 15.7768 6.33135 12.4394 -16.9523 -8.61752 -2.39927 +620 2 16.2545 6.83373 11.7966 11.5481 11.8457 -13.8092 +621 2 16.2346 6.49819 13.2509 8.584 1.06891 20.063 +622 1 16.7487 0.656157 9.53186 -1.89022 -32.3669 -10.6998 +623 2 16.6929 18.3191 9.69193 -1.14735 24.5709 0.588436 +624 2 16.3744 0.798362 8.64008 0.39513 1.76057 8.35052 +625 1 6.2256 11.6996 8.23382 -7.45249 -33.5883 4.29961 +626 2 5.41287 11.5766 8.79278 22.02 -5.73867 -21.2662 +627 2 6.53136 10.7979 7.88958 -15.1732 37.063 20.6987 +628 1 2.75779 8.608 0.340468 -48.3199 -4.33351 -7.97969 +629 2 2.08546 8.0585 18.4464 30.1073 27.602 24.3697 +630 2 2.23564 9.25518 0.892435 12.8354 -18.7139 -20.5564 +631 1 10.0773 10.2182 6.62419 2.67327 1.92209 4.62159 +632 2 10.5668 9.53044 7.10449 -1.07652 4.95909 -5.68289 +633 2 10.5655 10.3766 5.79827 -6.62323 -4.53969 7.46345 +634 1 6.84859 15.7294 6.8116 4.5172 -4.61086 -5.81045 +635 2 7.14728 16.2498 7.57791 -4.63192 -2.64256 -11.095 +636 2 7.17659 16.1616 6.00258 -4.95191 3.23702 9.76552 +637 1 6.62071 12.9207 5.93401 2.33655 2.8557 1.84805 +638 2 6.83452 13.8255 6.17261 -0.629609 6.79635 0.913528 +639 2 6.25462 12.5309 6.73716 -1.14115 0.401949 -5.14594 +640 1 16.7089 12.5339 9.77339 -0.869689 -1.39856 -8.71911 +641 2 16.7622 11.7819 9.15626 3.31473 10.0385 4.47785 +642 2 17.1611 13.2788 9.34464 -3.7572 -10.2702 6.17681 +643 1 6.29845 2.79213 2.75928 -3.20566 -14.4941 8.67087 +644 2 6.41489 3.68807 2.47435 5.42045 18.7619 -3.24562 +645 2 5.94058 2.32523 2.00482 -4.41542 -3.11109 -6.82659 +646 1 10.6289 2.95834 3.25769 -6.57134 8.8614 -3.08687 +647 2 10.3824 3.87829 3.42309 -0.834706 -5.50201 2.33367 +648 2 10.1446 2.71475 2.45701 2.51779 -3.35726 0.152255 diff --git a/examples/amoeba/dump.water_dimer.amoeba.1.test b/examples/amoeba/dump.water_dimer.amoeba.1.test new file mode 100644 index 0000000000..ec6d3eb2cd --- /dev/null +++ b/examples/amoeba/dump.water_dimer.amoeba.1.test @@ -0,0 +1,165 @@ +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.024616 -0.001154 -0.003748 7.94661 0.0143882 11.5654 +2 2 -0.244211 -0.000666 0.933978 -7.05777 -0.00770443 -3.06431 +3 2 0.932234 -0.000406 -0.008705 -0.956334 -0.00629552 -7.87238 +4 1 -0.892721 0.00012 2.77367 -12.7377 -0.00815373 2.78728 +5 2 -1.463 0.75512 2.93387 6.39935 4.06267 -1.71086 +6 2 -1.46181 -0.755549 2.93493 6.40581 -4.05491 -1.70517 +ITEM: TIMESTEP +10 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0210901 -0.00114727 0.00187855 -6.1441 -0.00926688 -6.30688 +2 2 -0.299755 -0.000716119 0.924842 7.69349 0.00623407 0.274054 +3 2 0.933941 -0.000453269 -0.0777281 -1.08824 0.00357639 6.29137 +4 1 -0.89902 0.000115499 2.77431 8.40057 0.0041921 -3.3195 +5 2 -1.41411 0.797948 2.92323 -4.42685 -5.12343 1.53409 +6 2 -1.41285 -0.798315 2.92435 -4.43485 5.1187 1.52687 +ITEM: TIMESTEP +20 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0253162 -0.0011519 9.30621e-06 6.65721 0.0114207 8.7962 +2 2 -0.214112 -0.000636438 0.94263 -7.71284 -0.00678668 -1.03908 +3 2 0.928921 -0.000430955 -0.0404651 0.717191 -0.00462784 -7.37266 +4 1 -0.894334 0.00011596 2.76974 -10.0965 -0.00568803 3.16137 +5 2 -1.45804 0.75449 2.94684 5.21348 5.11475 -1.77652 +6 2 -1.45685 -0.754893 2.9479 5.22149 -5.10907 -1.76931 +ITEM: TIMESTEP +30 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0221554 -0.0011439 0.00783939 -8.36895 -0.0130834 -9.24354 +2 2 -0.25261 -0.000667783 0.941075 6.36112 0.00692164 2.73081 +3 2 0.92432 -0.000494304 -0.125343 2.07038 0.00615069 6.42537 +4 1 -0.900866 0.00010992 2.76846 11.0986 0.00640696 -3.42785 +5 2 -1.40977 0.795072 2.93807 -5.57817 -3.04583 1.75974 +6 2 -1.40852 -0.795411 2.93919 -5.58301 3.03943 1.75548 +ITEM: TIMESTEP +40 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0269208 -0.00114842 0.00674288 5.42877 0.00730481 4.31748 +2 2 -0.171607 -0.000594964 0.954009 -8.40692 -0.00484075 2.50346 +3 2 0.92209 -0.000466908 -0.0840066 2.3456 -0.00296432 -6.82561 +4 1 -0.895716 0.000110956 2.76419 -6.18264 -0.00259137 3.07323 +5 2 -1.45218 0.754436 2.95353 3.40261 6.39649 -1.53879 +6 2 -1.45099 -0.75482 2.9546 3.41259 -6.3934 -1.52976 +ITEM: TIMESTEP +50 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0239329 -0.00114175 0.0128926 -8.15007 -0.014184 -11.0504 +2 2 -0.230937 -0.000644481 0.949766 5.72493 0.00756591 4.36142 +3 2 0.91871 -0.000511822 -0.144074 2.40885 0.00639366 6.3907 +4 1 -0.899724 0.000108594 2.76531 11.5106 0.00694105 -3.03119 +5 2 -1.41275 0.792848 2.92798 -5.74551 -2.08247 1.6662 +6 2 -1.41151 -0.793206 2.9291 -5.7488 2.07576 1.66327 +ITEM: TIMESTEP +60 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0287434 -0.0011479 0.00953424 6.82379 0.00862743 4.63675 +2 2 -0.180318 -0.000600308 0.956082 -8.03241 -0.00482631 2.10983 +3 2 0.922397 -0.000459471 -0.0739414 0.782565 -0.00412295 -6.72684 +4 1 -0.892694 0.000113827 2.76489 -6.55004 -0.00361317 2.26756 +5 2 -1.45749 0.757284 2.91975 3.48398 5.14308 -1.14726 +6 2 -1.4563 -0.757724 2.92081 3.49211 -5.13915 -1.14003 +ITEM: TIMESTEP +70 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.025848 -0.00114271 0.0136758 -6.10179 -0.0106002 -8.24377 +2 2 -0.259382 -0.000669072 0.94681 6.59121 0.0065405 1.93161 +3 2 0.923692 -0.000484045 -0.110366 -0.0484081 0.00428029 6.1322 +4 1 -0.894893 0.000114175 2.76783 7.43985 0.00424265 -2.1131 +5 2 -1.42416 0.79251 2.88639 -3.9377 -3.53776 1.14903 +6 2 -1.42292 -0.792944 2.88751 -3.94318 3.53329 1.14403 +ITEM: TIMESTEP +80 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.030135 -0.00114891 0.00965506 7.41429 0.0123912 9.3266 +2 2 -0.213346 -0.000627628 0.954378 -6.76672 -0.00675668 -2.04974 +3 2 0.924938 -0.000432456 -0.0385785 -0.591495 -0.00546702 -7.10385 +4 1 -0.888796 0.000119275 2.76827 -9.03539 -0.00642914 1.05959 +5 2 -1.46214 0.762697 2.87512 4.48797 2.10983 -0.617778 +6 2 -1.46094 -0.763208 2.87619 4.49133 -2.10357 -0.61482 +ITEM: TIMESTEP +90 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0270206 -0.00114299 0.0145983 -6.11813 -0.00811207 -4.69194 +2 2 -0.274281 -0.000680382 0.947366 7.50569 0.00503125 -1.23144 +3 2 0.92514 -0.000469353 -0.0912836 -0.650877 0.00352314 5.72916 +4 1 -0.891964 0.000116952 2.76852 3.17186 0.0014363 -1.52231 +5 2 -1.43137 0.791127 2.86377 -1.95059 -4.67792 0.861555 +6 2 -1.43013 -0.791605 2.86488 -1.95795 4.67604 0.85497 +ITEM: TIMESTEP +100 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.030669 -0.00114759 0.0121427 6.42493 0.0120997 10.0073 +2 2 -0.203569 -0.000615753 0.960107 -6.40597 -0.00736639 -3.30674 +3 2 0.923036 -0.000442107 -0.0503324 -0.0528607 -0.00477186 -6.71539 +4 1 -0.889443 0.000116814 2.76553 -7.7691 -0.0050422 1.37075 +5 2 -1.45671 0.76736 2.88018 3.9012 0.426437 -0.678284 +6 2 -1.4555 -0.767854 2.88126 3.9018 -0.421357 -0.677675 diff --git a/examples/amoeba/dump.water_dimer.amoeba.4.test b/examples/amoeba/dump.water_dimer.amoeba.4.test new file mode 100644 index 0000000000..ec6d3eb2cd --- /dev/null +++ b/examples/amoeba/dump.water_dimer.amoeba.4.test @@ -0,0 +1,165 @@ +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.024616 -0.001154 -0.003748 7.94661 0.0143882 11.5654 +2 2 -0.244211 -0.000666 0.933978 -7.05777 -0.00770443 -3.06431 +3 2 0.932234 -0.000406 -0.008705 -0.956334 -0.00629552 -7.87238 +4 1 -0.892721 0.00012 2.77367 -12.7377 -0.00815373 2.78728 +5 2 -1.463 0.75512 2.93387 6.39935 4.06267 -1.71086 +6 2 -1.46181 -0.755549 2.93493 6.40581 -4.05491 -1.70517 +ITEM: TIMESTEP +10 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0210901 -0.00114727 0.00187855 -6.1441 -0.00926688 -6.30688 +2 2 -0.299755 -0.000716119 0.924842 7.69349 0.00623407 0.274054 +3 2 0.933941 -0.000453269 -0.0777281 -1.08824 0.00357639 6.29137 +4 1 -0.89902 0.000115499 2.77431 8.40057 0.0041921 -3.3195 +5 2 -1.41411 0.797948 2.92323 -4.42685 -5.12343 1.53409 +6 2 -1.41285 -0.798315 2.92435 -4.43485 5.1187 1.52687 +ITEM: TIMESTEP +20 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0253162 -0.0011519 9.30621e-06 6.65721 0.0114207 8.7962 +2 2 -0.214112 -0.000636438 0.94263 -7.71284 -0.00678668 -1.03908 +3 2 0.928921 -0.000430955 -0.0404651 0.717191 -0.00462784 -7.37266 +4 1 -0.894334 0.00011596 2.76974 -10.0965 -0.00568803 3.16137 +5 2 -1.45804 0.75449 2.94684 5.21348 5.11475 -1.77652 +6 2 -1.45685 -0.754893 2.9479 5.22149 -5.10907 -1.76931 +ITEM: TIMESTEP +30 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0221554 -0.0011439 0.00783939 -8.36895 -0.0130834 -9.24354 +2 2 -0.25261 -0.000667783 0.941075 6.36112 0.00692164 2.73081 +3 2 0.92432 -0.000494304 -0.125343 2.07038 0.00615069 6.42537 +4 1 -0.900866 0.00010992 2.76846 11.0986 0.00640696 -3.42785 +5 2 -1.40977 0.795072 2.93807 -5.57817 -3.04583 1.75974 +6 2 -1.40852 -0.795411 2.93919 -5.58301 3.03943 1.75548 +ITEM: TIMESTEP +40 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0269208 -0.00114842 0.00674288 5.42877 0.00730481 4.31748 +2 2 -0.171607 -0.000594964 0.954009 -8.40692 -0.00484075 2.50346 +3 2 0.92209 -0.000466908 -0.0840066 2.3456 -0.00296432 -6.82561 +4 1 -0.895716 0.000110956 2.76419 -6.18264 -0.00259137 3.07323 +5 2 -1.45218 0.754436 2.95353 3.40261 6.39649 -1.53879 +6 2 -1.45099 -0.75482 2.9546 3.41259 -6.3934 -1.52976 +ITEM: TIMESTEP +50 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0239329 -0.00114175 0.0128926 -8.15007 -0.014184 -11.0504 +2 2 -0.230937 -0.000644481 0.949766 5.72493 0.00756591 4.36142 +3 2 0.91871 -0.000511822 -0.144074 2.40885 0.00639366 6.3907 +4 1 -0.899724 0.000108594 2.76531 11.5106 0.00694105 -3.03119 +5 2 -1.41275 0.792848 2.92798 -5.74551 -2.08247 1.6662 +6 2 -1.41151 -0.793206 2.9291 -5.7488 2.07576 1.66327 +ITEM: TIMESTEP +60 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0287434 -0.0011479 0.00953424 6.82379 0.00862743 4.63675 +2 2 -0.180318 -0.000600308 0.956082 -8.03241 -0.00482631 2.10983 +3 2 0.922397 -0.000459471 -0.0739414 0.782565 -0.00412295 -6.72684 +4 1 -0.892694 0.000113827 2.76489 -6.55004 -0.00361317 2.26756 +5 2 -1.45749 0.757284 2.91975 3.48398 5.14308 -1.14726 +6 2 -1.4563 -0.757724 2.92081 3.49211 -5.13915 -1.14003 +ITEM: TIMESTEP +70 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.025848 -0.00114271 0.0136758 -6.10179 -0.0106002 -8.24377 +2 2 -0.259382 -0.000669072 0.94681 6.59121 0.0065405 1.93161 +3 2 0.923692 -0.000484045 -0.110366 -0.0484081 0.00428029 6.1322 +4 1 -0.894893 0.000114175 2.76783 7.43985 0.00424265 -2.1131 +5 2 -1.42416 0.79251 2.88639 -3.9377 -3.53776 1.14903 +6 2 -1.42292 -0.792944 2.88751 -3.94318 3.53329 1.14403 +ITEM: TIMESTEP +80 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.030135 -0.00114891 0.00965506 7.41429 0.0123912 9.3266 +2 2 -0.213346 -0.000627628 0.954378 -6.76672 -0.00675668 -2.04974 +3 2 0.924938 -0.000432456 -0.0385785 -0.591495 -0.00546702 -7.10385 +4 1 -0.888796 0.000119275 2.76827 -9.03539 -0.00642914 1.05959 +5 2 -1.46214 0.762697 2.87512 4.48797 2.10983 -0.617778 +6 2 -1.46094 -0.763208 2.87619 4.49133 -2.10357 -0.61482 +ITEM: TIMESTEP +90 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0270206 -0.00114299 0.0145983 -6.11813 -0.00811207 -4.69194 +2 2 -0.274281 -0.000680382 0.947366 7.50569 0.00503125 -1.23144 +3 2 0.92514 -0.000469353 -0.0912836 -0.650877 0.00352314 5.72916 +4 1 -0.891964 0.000116952 2.76852 3.17186 0.0014363 -1.52231 +5 2 -1.43137 0.791127 2.86377 -1.95059 -4.67792 0.861555 +6 2 -1.43013 -0.791605 2.86488 -1.95795 4.67604 0.85497 +ITEM: TIMESTEP +100 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.030669 -0.00114759 0.0121427 6.42493 0.0120997 10.0073 +2 2 -0.203569 -0.000615753 0.960107 -6.40597 -0.00736639 -3.30674 +3 2 0.923036 -0.000442107 -0.0503324 -0.0528607 -0.00477186 -6.71539 +4 1 -0.889443 0.000116814 2.76553 -7.7691 -0.0050422 1.37075 +5 2 -1.45671 0.76736 2.88018 3.9012 0.426437 -0.678284 +6 2 -1.4555 -0.767854 2.88126 3.9018 -0.421357 -0.677675 diff --git a/examples/amoeba/dump.water_dimer.hippo.1.test b/examples/amoeba/dump.water_dimer.hippo.1.test new file mode 100644 index 0000000000..854055cac8 --- /dev/null +++ b/examples/amoeba/dump.water_dimer.hippo.1.test @@ -0,0 +1,165 @@ +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.024616 -0.001154 -0.003748 6.77815 0.012441 10.1043 +2 2 -0.244211 -0.000666 0.933978 -6.4757 -0.0067894 -2.41462 +3 2 0.932234 -0.000406 -0.008705 -0.41382 -0.00540908 -7.21892 +4 1 -0.892721 0.00012 2.77367 -11.9286 -0.00716387 3.29032 +5 2 -1.463 0.75512 2.93387 6.01759 3.00398 -1.88265 +6 2 -1.46181 -0.755549 2.93493 6.02238 -2.99706 -1.87845 +ITEM: TIMESTEP +10 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0215682 -0.00114805 0.0012979 -6.21268 -0.00924301 -6.19628 +2 2 -0.293095 -0.000710409 0.925512 6.99875 0.0060121 0.73377 +3 2 0.933101 -0.000449223 -0.0710512 -0.501529 0.00371221 5.82975 +4 1 -0.897884 0.000116793 2.77488 7.53966 0.00410482 -2.48587 +5 2 -1.42223 0.790989 2.91963 -3.9083 -4.87571 1.06275 +6 2 -1.42099 -0.791374 2.92075 -3.91591 4.87112 1.05588 +ITEM: TIMESTEP +20 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0258564 -0.00115245 -0.000173159 6.03126 0.0103631 7.9915 +2 2 -0.214264 -0.000636469 0.942735 -7.00136 -0.00592601 -0.60904 +3 2 0.929001 -0.000430037 -0.0392653 0.701856 -0.0043552 -6.96821 +4 1 -0.893054 0.000118973 2.77259 -8.83712 -0.00512625 2.54445 +5 2 -1.46387 0.753541 2.92502 4.54888 4.85296 -1.48277 +6 2 -1.46268 -0.753984 2.92608 4.55648 -4.84791 -1.47593 +ITEM: TIMESTEP +30 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0237238 -0.00114526 0.00766999 -7.81865 -0.0119879 -8.3015 +2 2 -0.241061 -0.000656856 0.943727 6.09288 0.0066852 2.69388 +3 2 0.923032 -0.000493736 -0.123121 1.75879 0.00552582 5.88556 +4 1 -0.897978 0.000115451 2.77309 11.6501 0.00727223 -2.82116 +5 2 -1.42536 0.788259 2.90023 -5.83991 -2.07218 1.27305 +6 2 -1.42412 -0.788676 2.90134 -5.84324 2.06468 1.27016 +ITEM: TIMESTEP +40 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0292005 -0.00114894 0.00855106 5.6712 0.00787804 4.86214 +2 2 -0.153199 -0.000576377 0.959922 -7.58451 -0.00449199 2.07976 +3 2 0.919336 -0.000480028 -0.0995905 1.37912 -0.00359093 -6.63778 +4 1 -0.89217 0.000118771 2.77132 -5.68638 -0.00321013 1.64962 +5 2 -1.47004 0.751887 2.88738 3.10503 6.73714 -0.981624 +6 2 -1.46886 -0.752392 2.88844 3.11554 -6.73373 -0.972121 +ITEM: TIMESTEP +50 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0276682 -0.00114169 0.0171537 -7.90829 -0.012452 -8.85967 +2 2 -0.185755 -0.000598779 0.964286 5.83022 0.00671605 3.0354 +3 2 0.908646 -0.000541992 -0.175729 1.96931 0.00577867 6.00768 +4 1 -0.895573 0.00011689 2.77245 11.8261 0.00822001 -1.54401 +5 2 -1.4336 0.787999 2.84603 -5.85703 -2.08185 0.681764 +6 2 -1.43237 -0.788505 2.84714 -5.86031 2.07358 0.678838 +ITEM: TIMESTEP +60 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0340777 -0.00114581 0.0184647 7.2272 0.00951667 5.4479 +2 2 -0.113434 -0.000533921 0.975674 -7.44659 -0.00496006 1.26816 +3 2 0.909471 -0.000512535 -0.134923 -0.287426 -0.00476073 -6.43846 +4 1 -0.888126 0.000122907 2.77269 -9.08281 -0.00670232 0.725333 +5 2 -1.47838 0.753365 2.8077 4.79099 4.82306 -0.504859 +6 2 -1.47719 -0.753996 2.80876 4.79863 -4.81616 -0.498076 +ITEM: TIMESTEP +70 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0329631 -0.00113896 0.0269437 -6.82209 -0.00981599 -6.32682 +2 2 -0.16378 -0.000570078 0.980622 6.44654 0.00529861 0.332147 +3 2 0.899135 -0.000560623 -0.191768 0.56204 0.00474764 6.11404 +4 1 -0.890774 0.0001215 2.77364 7.6207 0.00561833 -0.364449 +5 2 -1.4359 0.790393 2.75878 -3.89983 -4.84574 0.12595 +6 2 -1.43466 -0.791026 2.7599 -3.90736 4.83989 0.11913 +ITEM: TIMESTEP +80 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0396799 -0.00114299 0.0287108 8.10782 0.0121934 8.26954 +2 2 -0.101327 -0.000514632 0.989821 -6.98655 -0.00644087 -1.35375 +3 2 0.902079 -0.000521504 -0.139604 -1.23495 -0.0056704 -6.67396 +4 1 -0.883488 0.000127321 2.77377 -12.2256 -0.0109573 -1.83848 +5 2 -1.47309 0.755263 2.71301 6.16734 2.89071 0.796293 +6 2 -1.4719 -0.756019 2.71407 6.17192 -2.87983 0.800362 +ITEM: TIMESTEP +90 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0383179 -0.00113532 0.0380883 -7.16334 -0.00889532 -4.6369 +2 2 -0.149498 -0.00054848 0.995531 6.83221 0.00448143 -1.26419 +3 2 0.889431 -0.00057205 -0.197356 0.916 0.00477871 5.76452 +4 1 -0.886952 0.000122589 2.77093 7.29365 0.00587785 0.155791 +5 2 -1.42602 0.790491 2.68716 -3.93543 -4.86013 -0.00619146 +6 2 -1.42478 -0.791209 2.68827 -3.94309 4.85389 -0.0130349 +ITEM: TIMESTEP +100 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0443853 -0.00113803 0.0410221 7.36858 0.0108291 7.15279 +2 2 -0.076648 -0.000485983 1.00287 -6.96363 -0.00585609 -0.543819 +3 2 0.890615 -0.000542732 -0.157107 -0.3904 -0.00504823 -6.73186 +4 1 -0.880834 0.000124898 2.7674 -9.13947 -0.00841726 -1.90715 +5 2 -1.46341 0.754149 2.66816 4.55895 4.52404 1.01184 +6 2 -1.46222 -0.754952 2.66922 4.56597 -4.51554 1.01819 diff --git a/examples/amoeba/dump.water_dimer.hippo.4.test b/examples/amoeba/dump.water_dimer.hippo.4.test new file mode 100644 index 0000000000..854055cac8 --- /dev/null +++ b/examples/amoeba/dump.water_dimer.hippo.4.test @@ -0,0 +1,165 @@ +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.024616 -0.001154 -0.003748 6.77815 0.012441 10.1043 +2 2 -0.244211 -0.000666 0.933978 -6.4757 -0.0067894 -2.41462 +3 2 0.932234 -0.000406 -0.008705 -0.41382 -0.00540908 -7.21892 +4 1 -0.892721 0.00012 2.77367 -11.9286 -0.00716387 3.29032 +5 2 -1.463 0.75512 2.93387 6.01759 3.00398 -1.88265 +6 2 -1.46181 -0.755549 2.93493 6.02238 -2.99706 -1.87845 +ITEM: TIMESTEP +10 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0215682 -0.00114805 0.0012979 -6.21268 -0.00924301 -6.19628 +2 2 -0.293095 -0.000710409 0.925512 6.99875 0.0060121 0.73377 +3 2 0.933101 -0.000449223 -0.0710512 -0.501529 0.00371221 5.82975 +4 1 -0.897884 0.000116793 2.77488 7.53966 0.00410482 -2.48587 +5 2 -1.42223 0.790989 2.91963 -3.9083 -4.87571 1.06275 +6 2 -1.42099 -0.791374 2.92075 -3.91591 4.87112 1.05588 +ITEM: TIMESTEP +20 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0258564 -0.00115245 -0.000173159 6.03126 0.0103631 7.9915 +2 2 -0.214264 -0.000636469 0.942735 -7.00136 -0.00592601 -0.60904 +3 2 0.929001 -0.000430037 -0.0392653 0.701856 -0.0043552 -6.96821 +4 1 -0.893054 0.000118973 2.77259 -8.83712 -0.00512625 2.54445 +5 2 -1.46387 0.753541 2.92502 4.54888 4.85296 -1.48277 +6 2 -1.46268 -0.753984 2.92608 4.55648 -4.84791 -1.47593 +ITEM: TIMESTEP +30 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0237238 -0.00114526 0.00766999 -7.81865 -0.0119879 -8.3015 +2 2 -0.241061 -0.000656856 0.943727 6.09288 0.0066852 2.69388 +3 2 0.923032 -0.000493736 -0.123121 1.75879 0.00552582 5.88556 +4 1 -0.897978 0.000115451 2.77309 11.6501 0.00727223 -2.82116 +5 2 -1.42536 0.788259 2.90023 -5.83991 -2.07218 1.27305 +6 2 -1.42412 -0.788676 2.90134 -5.84324 2.06468 1.27016 +ITEM: TIMESTEP +40 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0292005 -0.00114894 0.00855106 5.6712 0.00787804 4.86214 +2 2 -0.153199 -0.000576377 0.959922 -7.58451 -0.00449199 2.07976 +3 2 0.919336 -0.000480028 -0.0995905 1.37912 -0.00359093 -6.63778 +4 1 -0.89217 0.000118771 2.77132 -5.68638 -0.00321013 1.64962 +5 2 -1.47004 0.751887 2.88738 3.10503 6.73714 -0.981624 +6 2 -1.46886 -0.752392 2.88844 3.11554 -6.73373 -0.972121 +ITEM: TIMESTEP +50 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0276682 -0.00114169 0.0171537 -7.90829 -0.012452 -8.85967 +2 2 -0.185755 -0.000598779 0.964286 5.83022 0.00671605 3.0354 +3 2 0.908646 -0.000541992 -0.175729 1.96931 0.00577867 6.00768 +4 1 -0.895573 0.00011689 2.77245 11.8261 0.00822001 -1.54401 +5 2 -1.4336 0.787999 2.84603 -5.85703 -2.08185 0.681764 +6 2 -1.43237 -0.788505 2.84714 -5.86031 2.07358 0.678838 +ITEM: TIMESTEP +60 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0340777 -0.00114581 0.0184647 7.2272 0.00951667 5.4479 +2 2 -0.113434 -0.000533921 0.975674 -7.44659 -0.00496006 1.26816 +3 2 0.909471 -0.000512535 -0.134923 -0.287426 -0.00476073 -6.43846 +4 1 -0.888126 0.000122907 2.77269 -9.08281 -0.00670232 0.725333 +5 2 -1.47838 0.753365 2.8077 4.79099 4.82306 -0.504859 +6 2 -1.47719 -0.753996 2.80876 4.79863 -4.81616 -0.498076 +ITEM: TIMESTEP +70 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0329631 -0.00113896 0.0269437 -6.82209 -0.00981599 -6.32682 +2 2 -0.16378 -0.000570078 0.980622 6.44654 0.00529861 0.332147 +3 2 0.899135 -0.000560623 -0.191768 0.56204 0.00474764 6.11404 +4 1 -0.890774 0.0001215 2.77364 7.6207 0.00561833 -0.364449 +5 2 -1.4359 0.790393 2.75878 -3.89983 -4.84574 0.12595 +6 2 -1.43466 -0.791026 2.7599 -3.90736 4.83989 0.11913 +ITEM: TIMESTEP +80 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0396799 -0.00114299 0.0287108 8.10782 0.0121934 8.26954 +2 2 -0.101327 -0.000514632 0.989821 -6.98655 -0.00644087 -1.35375 +3 2 0.902079 -0.000521504 -0.139604 -1.23495 -0.0056704 -6.67396 +4 1 -0.883488 0.000127321 2.77377 -12.2256 -0.0109573 -1.83848 +5 2 -1.47309 0.755263 2.71301 6.16734 2.89071 0.796293 +6 2 -1.4719 -0.756019 2.71407 6.17192 -2.87983 0.800362 +ITEM: TIMESTEP +90 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0383179 -0.00113532 0.0380883 -7.16334 -0.00889532 -4.6369 +2 2 -0.149498 -0.00054848 0.995531 6.83221 0.00448143 -1.26419 +3 2 0.889431 -0.00057205 -0.197356 0.916 0.00477871 5.76452 +4 1 -0.886952 0.000122589 2.77093 7.29365 0.00587785 0.155791 +5 2 -1.42602 0.790491 2.68716 -3.93543 -4.86013 -0.00619146 +6 2 -1.42478 -0.791209 2.68827 -3.94309 4.85389 -0.0130349 +ITEM: TIMESTEP +100 +ITEM: NUMBER OF ATOMS +6 +ITEM: BOX BOUNDS ss ss ss +-1.4632357229999999e+00 9.3247372299999998e-01 +-7.5570026690000003e-01 7.5527126690000002e-01 +-8.9995638999999985e-03 2.9352285639000000e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -0.0443853 -0.00113803 0.0410221 7.36858 0.0108291 7.15279 +2 2 -0.076648 -0.000485983 1.00287 -6.96363 -0.00585609 -0.543819 +3 2 0.890615 -0.000542732 -0.157107 -0.3904 -0.00504823 -6.73186 +4 1 -0.880834 0.000124898 2.7674 -9.13947 -0.00841726 -1.90715 +5 2 -1.46341 0.754149 2.66816 4.55895 4.52404 1.01184 +6 2 -1.46222 -0.754952 2.66922 4.56597 -4.51554 1.01819 diff --git a/examples/amoeba/dump.water_hexamer.amoeba.1.test b/examples/amoeba/dump.water_hexamer.amoeba.1.test new file mode 100644 index 0000000000..88e888cc45 --- /dev/null +++ b/examples/amoeba/dump.water_hexamer.amoeba.1.test @@ -0,0 +1,297 @@ +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.50217 -0.191359 1.43493 15.8836 -7.45837 3.84323 +2 2 -0.601054 -0.596972 1.55372 -22.9153 9.01978 -0.990133 +3 2 -2.0067 -0.422327 2.21985 1.01155 0.118537 -0.791932 +4 1 -1.74457 -0.382348 -1.30914 -6.66041 -3.92202 8.41554 +5 2 -1.88894 -0.479653 -0.347624 4.77968 3.15053 -8.64245 +6 2 -2.51683 -0.766765 -1.73377 2.90782 1.57916 -0.744558 +7 1 -0.560409 2.01783 -0.121984 -13.2194 -12.8195 1.43178 +8 2 -0.94772 1.53357 0.625228 6.08473 6.021 -1.58068 +9 2 -0.989831 1.59274 -0.877419 5.83415 5.52991 -0.337029 +10 1 0.964803 -1.16576 1.43999 12.6547 2.88136 -21.3636 +11 2 0.979557 -1.52204 0.527833 -3.6968 -1.92725 12.6575 +12 2 1.54222 -0.393692 1.34437 -3.37883 -2.73031 5.998 +13 1 0.974705 -1.4015 -1.33597 -6.12193 14.8514 -0.790538 +14 2 0.065161 -1.11895 -1.52289 4.56017 -6.05436 1.71545 +15 2 1.47071 -0.570933 -1.27771 1.31912 -7.40942 1.06098 +16 1 2.00228 1.05782 -0.124502 -10.3736 10.8414 -1.12005 +17 2 1.14164 1.53227 -0.140121 11.8812 -8.20067 0.772116 +18 2 2.67472 1.73534 -0.237995 -0.550493 -3.47117 0.466398 +ITEM: TIMESTEP +10 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.50661 -0.189383 1.4364 14.5938 -8.99605 8.72579 +2 2 -0.616993 -0.604745 1.5716 -17.7352 9.03346 -4.01613 +3 2 -2.01184 -0.421588 2.22126 -0.664878 1.39015 -2.52743 +4 1 -1.74564 -0.383429 -1.31051 0.451442 -0.432875 3.71075 +5 2 -1.85676 -0.451272 -0.342641 -1.17801 0.27861 -9.12816 +6 2 -2.51648 -0.764704 -1.74119 1.00433 0.523826 3.94489 +7 1 -0.565581 2.01415 -0.121947 -0.431671 0.816258 1.37224 +8 2 -0.923503 1.54613 0.649943 -0.836345 -0.35076 -8.91816 +9 2 -0.954982 1.61593 -0.9136 -0.398984 -1.29665 6.9827 +10 1 0.971315 -1.16462 1.43403 2.66632 -4.10463 -4.1745 +11 2 0.960388 -1.57587 0.54557 3.80791 8.56867 8.0783 +12 2 1.545 -0.38505 1.37422 -2.3984 -5.62816 -5.66197 +13 1 0.972827 -1.39712 -1.33549 -1.10638 0.442925 0.267527 +14 2 0.0526434 -1.14464 -1.51395 7.06933 2.8298 1.48943 +15 2 1.50554 -0.590868 -1.25662 -6.54392 -2.53639 -0.258333 +16 1 2.00275 1.0584 -0.124848 -7.13185 5.38221 -0.0306111 +17 2 1.13969 1.52381 -0.134074 11.7308 -4.5992 -0.113372 +18 2 2.68869 1.72277 -0.237084 -2.89819 -1.32119 0.257039 +ITEM: TIMESTEP +20 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.51649 -0.18584 1.44395 5.65501 -4.20149 4.07802 +2 2 -0.637196 -0.60535 1.5789 -10.2535 4.51311 -0.350867 +3 2 -2.05196 -0.408647 2.21473 3.52072 0.575858 -3.20585 +4 1 -1.74216 -0.383007 -1.31779 -5.65244 -1.7459 7.46957 +5 2 -1.85838 -0.422286 -0.35262 3.57624 0.698487 -5.03248 +6 2 -2.53778 -0.772973 -1.68856 2.62304 1.05785 -2.46299 +7 1 -0.568621 2.01502 -0.121788 -7.49291 -10.5083 -0.07078 +8 2 -0.953332 1.50031 0.601729 3.90339 5.1027 1.32659 +9 2 -0.948304 1.59097 -0.90055 3.2198 4.86429 -1.5712 +10 1 0.981527 -1.16776 1.43139 8.19382 2.30469 -14.0571 +11 2 0.999682 -1.57682 0.548153 -4.17545 -1.46604 7.90595 +12 2 1.55686 -0.401102 1.29785 -3.41945 -1.35828 5.31582 +13 1 0.971997 -1.39727 -1.33295 -3.50737 11.1512 0.685267 +14 2 0.0679408 -1.0929 -1.49373 1.59713 -5.72522 -0.144088 +15 2 1.47933 -0.582056 -1.22295 2.04209 -4.76253 -0.234646 +16 1 2.00557 1.05551 -0.12468 -4.4992 7.40197 -0.448564 +17 2 1.16008 1.5422 -0.129327 5.1837 -4.83397 0.46283 +18 2 2.69054 1.72007 -0.238059 -0.51465 -3.06849 0.334482 +ITEM: TIMESTEP +30 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.52872 -0.18011 1.45173 -0.933277 -2.21949 5.98424 +2 2 -0.665459 -0.602256 1.60472 0.633036 0.719099 -1.22127 +3 2 -2.07366 -0.404666 2.21589 2.60377 1.4581 -4.42661 +4 1 -1.74225 -0.382648 -1.3226 2.4731 1.57235 -0.799694 +5 2 -1.81423 -0.398932 -0.35676 -3.06045 -1.92828 -1.63228 +6 2 -2.5352 -0.77665 -1.69294 0.0233925 -0.139311 2.03217 +7 1 -0.576286 2.0073 -0.122823 5.68391 5.42307 0.543301 +8 2 -0.95235 1.50691 0.611905 -2.48677 -2.29116 -3.6455 +9 2 -0.915502 1.63076 -0.941481 -3.12923 -3.02599 2.90572 +10 1 0.998541 -1.16996 1.42191 -2.76709 -0.0175982 4.85417 +11 2 0.970261 -1.63876 0.575717 2.4618 4.28015 -0.493825 +12 2 1.54742 -0.386783 1.27666 -1.41861 -3.70889 -3.67396 +13 1 0.969317 -1.3895 -1.32829 2.03562 -5.48364 0.295138 +14 2 0.0583035 -1.11723 -1.49206 1.73159 3.49229 -0.0543931 +15 2 1.50655 -0.600283 -1.19205 -3.9925 1.94925 -1.04523 +16 1 2.00848 1.05446 -0.124132 1.88868 -1.58075 0.754117 +17 2 1.16959 1.53865 -0.11771 0.573913 1.34283 -0.58573 +18 2 2.71517 1.69464 -0.239075 -2.32089 0.157967 0.209615 +ITEM: TIMESTEP +40 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.53726 -0.175397 1.46121 -7.56641 2.45844 -0.518817 +2 2 -0.675238 -0.584022 1.60915 7.85196 -3.99237 1.67217 +3 2 -2.08862 -0.402087 2.21789 3.0617 0.39778 -2.04562 +4 1 -1.73949 -0.379604 -1.32819 -2.36016 -0.787528 -0.0315325 +5 2 -1.83346 -0.428429 -0.37056 1.90026 0.717301 4.17358 +6 2 -2.53017 -0.786871 -1.68316 0.151557 -0.108901 -3.75615 +7 1 -0.576955 2.0043 -0.124416 -0.431513 -1.54355 -1.46354 +8 2 -0.992092 1.48382 0.567817 1.09284 0.418387 6.78235 +9 2 -0.944746 1.62819 -0.925975 0.76441 1.37882 -5.22407 +10 1 1.00941 -1.17308 1.4189 -1.85973 4.64458 1.0889 +11 2 0.973659 -1.6403 0.580693 -1.69219 -4.78957 -3.29195 +12 2 1.53559 -0.396477 1.19908 0.544307 1.46508 3.63166 +13 1 0.969009 -1.38744 -1.3228 -0.275569 1.85307 -0.63583 +14 2 0.0737932 -1.09141 -1.50366 -4.66851 -2.83882 -1.16892 +15 2 1.46633 -0.576681 -1.19175 5.00795 0.70617 0.521536 +16 1 2.01183 1.05054 -0.121932 4.41526 -1.70685 -0.0836272 +17 2 1.19121 1.55327 -0.120038 -7.25224 2.19125 0.154184 +18 2 2.71636 1.68982 -0.237383 1.31607 -0.463304 0.195666 +ITEM: TIMESTEP +50 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.53986 -0.172749 1.46865 -10.3641 5.96951 -4.41562 +2 2 -0.678724 -0.568486 1.60775 14.9207 -7.13278 2.04782 +3 2 -2.07217 -0.405364 2.23045 -0.725799 -0.490948 1.77161 +4 1 -1.74113 -0.378171 -1.32957 5.99712 2.85952 -9.13842 +5 2 -1.82713 -0.447378 -0.375703 -3.89226 -1.3818 7.11516 +6 2 -2.4999 -0.790471 -1.74187 -3.02333 -1.60416 1.77146 +7 1 -0.579496 1.99691 -0.128028 9.72738 10.7655 -0.463519 +8 2 -0.97832 1.50522 0.591572 -4.4866 -5.64841 2.33138 +9 2 -0.951447 1.66071 -0.944057 -3.97244 -4.92262 -1.79974 +10 1 1.01358 -1.17192 1.41393 -6.48605 2.83151 13.495 +11 2 0.960671 -1.668 0.598799 0.887838 -3.18341 -9.75086 +12 2 1.53449 -0.394669 1.19537 2.46945 2.14925 -1.89795 +13 1 0.966791 -1.38037 -1.31946 4.73561 -12.449 -1.17286 +14 2 0.0653014 -1.12956 -1.52441 -4.76491 5.51904 -0.304595 +15 2 1.48076 -0.580834 -1.19775 0.0522693 6.36707 0.249418 +16 1 2.01309 1.04924 -0.119438 7.79557 -11.0594 0.778107 +17 2 1.18753 1.53519 -0.124654 -9.57007 7.63584 -0.456674 +18 2 2.72824 1.67508 -0.226016 0.699647 3.77524 -0.159727 +ITEM: TIMESTEP +60 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.535 -0.173529 1.47468 -12.8115 9.37187 -10.8344 +2 2 -0.673508 -0.564245 1.59147 19.3914 -9.12777 2.73797 +3 2 -2.04099 -0.404174 2.24807 -3.82175 -1.70255 6.71674 +4 1 -1.73996 -0.376347 -1.33351 0.570165 0.280665 -6.43548 +5 2 -1.87928 -0.466718 -0.390362 1.26398 0.876645 10.7815 +6 2 -2.48657 -0.801116 -1.75201 -2.14828 -1.00411 -3.66812 +7 1 -0.576718 1.99595 -0.131852 3.14419 3.30092 -1.47913 +8 2 -0.97416 1.49195 0.577492 -1.32391 -2.58987 8.72867 +9 2 -0.983297 1.63168 -0.91691 -0.334419 -0.770035 -7.07098 +10 1 1.00791 -1.1681 1.41401 -6.20027 1.07549 12.575 +11 2 0.972875 -1.65454 0.593802 -0.476084 -5.46772 -10.3478 +12 2 1.54632 -0.404877 1.20306 3.83119 5.88484 -0.834958 +13 1 0.966385 -1.38017 -1.32091 1.49436 -4.60495 -1.57148 +14 2 0.0722824 -1.10128 -1.51274 -8.16812 -0.531008 -1.13308 +15 2 1.45394 -0.565765 -1.20718 7.01226 4.42564 1.66198 +16 1 2.01308 1.04537 -0.116618 6.94232 -7.944 0.350248 +17 2 1.19126 1.53332 -0.135036 -13.3157 5.74475 0.221956 +18 2 2.70715 1.69348 -0.205764 4.95008 2.7812 -0.398561 +ITEM: TIMESTEP +70 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.52447 -0.177745 1.47754 -14.009 12.5988 -14.9127 +2 2 -0.663619 -0.56979 1.57126 20.9018 -10.2143 3.8986 +3 2 -2.00537 -0.388653 2.26816 -5.41735 -2.91391 10.0958 +4 1 -1.74327 -0.377755 -1.33511 7.69657 4.1782 -9.73798 +5 2 -1.88018 -0.439682 -0.388162 -4.07322 -2.33918 9.17346 +6 2 -2.47021 -0.801057 -1.79014 -4.11028 -2.07522 1.70143 +7 1 -0.576352 1.99233 -0.135801 8.33914 8.33997 -1.40304 +8 2 -0.93279 1.50467 0.607511 -5.01196 -5.05095 3.69276 +9 2 -0.967697 1.61396 -0.924499 -2.96791 -3.60448 -2.11522 +10 1 0.996682 -1.16249 1.41603 -5.52393 -2.7768 9.00886 +11 2 0.982553 -1.62276 0.577115 -1.00274 -4.80219 -7.71302 +12 2 1.55168 -0.404501 1.24312 4.97383 8.09577 -0.603791 +13 1 0.964232 -1.37715 -1.32734 3.83388 -12.0598 -0.0980446 +14 2 0.0575072 -1.10802 -1.48098 -4.628 4.85469 -1.01689 +15 2 1.48931 -0.58697 -1.19891 1.1914 7.02562 -0.119366 +16 1 2.01083 1.04528 -0.114231 6.83173 -12.9986 1.26494 +17 2 1.17034 1.50303 -0.133551 -9.79274 8.34256 -0.476042 +18 2 2.7022 1.69874 -0.182183 2.76884 5.3999 -0.639748 +ITEM: TIMESTEP +80 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.51177 -0.182537 1.47592 -13.1365 10.3139 -11.8951 +2 2 -0.654143 -0.583091 1.57918 18.6975 -8.17701 1.44433 +3 2 -1.97348 -0.365352 2.2852 -6.58467 -1.56222 9.05296 +4 1 -1.74352 -0.377279 -1.33693 -0.505822 0.308788 -3.25308 +5 2 -1.91188 -0.438855 -0.39405 1.95743 0.358158 9.20234 +6 2 -2.48397 -0.807922 -1.76244 -1.16931 -0.70018 -3.86005 +7 1 -0.571778 1.99034 -0.138544 1.3921 0.315501 -1.43854 +8 2 -0.938419 1.50232 0.602337 -1.22478 -1.30903 4.8686 +9 2 -0.959599 1.56918 -0.90914 -0.0288155 0.574454 -3.52808 +10 1 0.985435 -1.15713 1.41811 -6.25848 -6.25702 9.27302 +11 2 0.972167 -1.59168 0.560031 1.69554 -0.201305 -5.06875 +12 2 1.54032 -0.386652 1.30283 4.96928 5.72762 -4.15176 +13 1 0.963614 -1.3793 -1.33436 0.183354 -1.1048 0.823621 +14 2 0.065336 -1.06423 -1.45856 -4.4409 -1.33366 -2.05511 +15 2 1.49256 -0.587857 -1.21654 4.36346 2.23441 0.338535 +16 1 2.00803 1.04345 -0.110717 3.61274 -3.25471 0.639326 +17 2 1.16919 1.51061 -0.133404 -8.46417 2.50048 0.10369 +18 2 2.67828 1.72068 -0.16597 4.94198 1.56662 -0.49597 +ITEM: TIMESTEP +90 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.50159 -0.186388 1.47232 -10.1666 8.56134 -9.06842 +2 2 -0.637201 -0.589948 1.58141 9.00709 -5.13609 3.43504 +3 2 -1.97805 -0.327506 2.28752 -1.76215 -2.05269 5.01359 +4 1 -1.7485 -0.377921 -1.33249 5.81313 3.27044 -5.4853 +5 2 -1.87141 -0.433051 -0.37781 -3.50795 -2.5324 4.09176 +6 2 -2.48522 -0.804273 -1.77362 -2.18894 -1.0456 2.79096 +7 1 -0.568425 1.98378 -0.140489 1.33268 1.60885 -0.760228 +8 2 -0.945484 1.51375 0.61188 -1.03442 -1.79649 -0.570033 +9 2 -0.936389 1.56212 -0.924193 -1.07342 -0.200973 1.02154 +10 1 0.975854 -1.15481 1.42351 1.86741 -2.52595 -4.21318 +11 2 0.98193 -1.53917 0.537259 -2.6087 -4.02599 1.03016 +12 2 1.52752 -0.379325 1.30866 2.98513 5.11632 2.51897 +13 1 0.962056 -1.37771 -1.33914 1.58342 -3.36145 0.893222 +14 2 0.0608833 -1.06855 -1.4877 0.530861 1.7595 -0.414339 +15 2 1.52774 -0.603203 -1.25083 -2.15602 1.98356 -0.537593 +16 1 2.00483 1.04652 -0.10624 2.44039 -5.05754 0.604689 +17 2 1.15126 1.49959 -0.126569 -0.261743 3.34267 -0.115684 +18 2 2.69252 1.71134 -0.15978 -0.800158 2.09248 -0.235157 +ITEM: TIMESTEP +100 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.49915 -0.184572 1.46491 -1.64286 -0.923423 4.11541 +2 2 -0.634606 -0.601439 1.61658 -0.503947 1.48506 -2.91046 +3 2 -1.9835 -0.312527 2.28463 -1.23961 0.673264 -1.96712 +4 1 -1.74898 -0.375873 -1.32741 -4.05983 -3.09974 1.92324 +5 2 -1.86884 -0.471305 -0.372769 3.24632 2.33491 1.76011 +6 2 -2.50916 -0.806172 -1.72327 1.14638 0.924599 -3.12385 +7 1 -0.564884 1.97778 -0.142101 -4.14881 -3.0738 -0.168062 +8 2 -0.958996 1.4911 0.595477 2.25574 1.20147 -1.85844 +9 2 -0.937749 1.56372 -0.930264 1.31445 2.00952 1.76263 +10 1 0.975211 -1.15256 1.42364 -0.947501 -4.6035 2.62584 +11 2 0.950951 -1.55837 0.541757 3.10583 4.89391 1.85772 +12 2 1.52342 -0.363228 1.34082 0.672959 -1.69053 -5.30235 +13 1 0.962361 -1.37851 -1.34242 -1.40487 6.54708 -1.50719 +14 2 0.0703818 -1.05861 -1.53269 1.44041 -3.14031 1.12109 +15 2 1.51335 -0.586474 -1.29057 -0.612624 -3.69916 1.63647 +16 1 2.00445 1.04687 -0.100669 -1.02523 8.04786 -0.336895 +17 2 1.16075 1.52969 -0.119062 2.24423 -4.67525 0.190963 +18 2 2.68635 1.72058 -0.160395 0.158945 -3.21195 0.180894 diff --git a/examples/amoeba/dump.water_hexamer.amoeba.4.test b/examples/amoeba/dump.water_hexamer.amoeba.4.test new file mode 100644 index 0000000000..88e888cc45 --- /dev/null +++ b/examples/amoeba/dump.water_hexamer.amoeba.4.test @@ -0,0 +1,297 @@ +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.50217 -0.191359 1.43493 15.8836 -7.45837 3.84323 +2 2 -0.601054 -0.596972 1.55372 -22.9153 9.01978 -0.990133 +3 2 -2.0067 -0.422327 2.21985 1.01155 0.118537 -0.791932 +4 1 -1.74457 -0.382348 -1.30914 -6.66041 -3.92202 8.41554 +5 2 -1.88894 -0.479653 -0.347624 4.77968 3.15053 -8.64245 +6 2 -2.51683 -0.766765 -1.73377 2.90782 1.57916 -0.744558 +7 1 -0.560409 2.01783 -0.121984 -13.2194 -12.8195 1.43178 +8 2 -0.94772 1.53357 0.625228 6.08473 6.021 -1.58068 +9 2 -0.989831 1.59274 -0.877419 5.83415 5.52991 -0.337029 +10 1 0.964803 -1.16576 1.43999 12.6547 2.88136 -21.3636 +11 2 0.979557 -1.52204 0.527833 -3.6968 -1.92725 12.6575 +12 2 1.54222 -0.393692 1.34437 -3.37883 -2.73031 5.998 +13 1 0.974705 -1.4015 -1.33597 -6.12193 14.8514 -0.790538 +14 2 0.065161 -1.11895 -1.52289 4.56017 -6.05436 1.71545 +15 2 1.47071 -0.570933 -1.27771 1.31912 -7.40942 1.06098 +16 1 2.00228 1.05782 -0.124502 -10.3736 10.8414 -1.12005 +17 2 1.14164 1.53227 -0.140121 11.8812 -8.20067 0.772116 +18 2 2.67472 1.73534 -0.237995 -0.550493 -3.47117 0.466398 +ITEM: TIMESTEP +10 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.50661 -0.189383 1.4364 14.5938 -8.99605 8.72579 +2 2 -0.616993 -0.604745 1.5716 -17.7352 9.03346 -4.01613 +3 2 -2.01184 -0.421588 2.22126 -0.664878 1.39015 -2.52743 +4 1 -1.74564 -0.383429 -1.31051 0.451442 -0.432875 3.71075 +5 2 -1.85676 -0.451272 -0.342641 -1.17801 0.27861 -9.12816 +6 2 -2.51648 -0.764704 -1.74119 1.00433 0.523826 3.94489 +7 1 -0.565581 2.01415 -0.121947 -0.431671 0.816258 1.37224 +8 2 -0.923503 1.54613 0.649943 -0.836345 -0.35076 -8.91816 +9 2 -0.954982 1.61593 -0.9136 -0.398984 -1.29665 6.9827 +10 1 0.971315 -1.16462 1.43403 2.66632 -4.10463 -4.1745 +11 2 0.960388 -1.57587 0.54557 3.80791 8.56867 8.0783 +12 2 1.545 -0.38505 1.37422 -2.3984 -5.62816 -5.66197 +13 1 0.972827 -1.39712 -1.33549 -1.10638 0.442925 0.267527 +14 2 0.0526434 -1.14464 -1.51395 7.06933 2.8298 1.48943 +15 2 1.50554 -0.590868 -1.25662 -6.54392 -2.53639 -0.258333 +16 1 2.00275 1.0584 -0.124848 -7.13185 5.38221 -0.0306111 +17 2 1.13969 1.52381 -0.134074 11.7308 -4.5992 -0.113372 +18 2 2.68869 1.72277 -0.237084 -2.89819 -1.32119 0.257039 +ITEM: TIMESTEP +20 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.51649 -0.18584 1.44395 5.65501 -4.20149 4.07802 +2 2 -0.637196 -0.60535 1.5789 -10.2535 4.51311 -0.350867 +3 2 -2.05196 -0.408647 2.21473 3.52072 0.575858 -3.20585 +4 1 -1.74216 -0.383007 -1.31779 -5.65244 -1.7459 7.46957 +5 2 -1.85838 -0.422286 -0.35262 3.57624 0.698487 -5.03248 +6 2 -2.53778 -0.772973 -1.68856 2.62304 1.05785 -2.46299 +7 1 -0.568621 2.01502 -0.121788 -7.49291 -10.5083 -0.07078 +8 2 -0.953332 1.50031 0.601729 3.90339 5.1027 1.32659 +9 2 -0.948304 1.59097 -0.90055 3.2198 4.86429 -1.5712 +10 1 0.981527 -1.16776 1.43139 8.19382 2.30469 -14.0571 +11 2 0.999682 -1.57682 0.548153 -4.17545 -1.46604 7.90595 +12 2 1.55686 -0.401102 1.29785 -3.41945 -1.35828 5.31582 +13 1 0.971997 -1.39727 -1.33295 -3.50737 11.1512 0.685267 +14 2 0.0679408 -1.0929 -1.49373 1.59713 -5.72522 -0.144088 +15 2 1.47933 -0.582056 -1.22295 2.04209 -4.76253 -0.234646 +16 1 2.00557 1.05551 -0.12468 -4.4992 7.40197 -0.448564 +17 2 1.16008 1.5422 -0.129327 5.1837 -4.83397 0.46283 +18 2 2.69054 1.72007 -0.238059 -0.51465 -3.06849 0.334482 +ITEM: TIMESTEP +30 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.52872 -0.18011 1.45173 -0.933277 -2.21949 5.98424 +2 2 -0.665459 -0.602256 1.60472 0.633036 0.719099 -1.22127 +3 2 -2.07366 -0.404666 2.21589 2.60377 1.4581 -4.42661 +4 1 -1.74225 -0.382648 -1.3226 2.4731 1.57235 -0.799694 +5 2 -1.81423 -0.398932 -0.35676 -3.06045 -1.92828 -1.63228 +6 2 -2.5352 -0.77665 -1.69294 0.0233925 -0.139311 2.03217 +7 1 -0.576286 2.0073 -0.122823 5.68391 5.42307 0.543301 +8 2 -0.95235 1.50691 0.611905 -2.48677 -2.29116 -3.6455 +9 2 -0.915502 1.63076 -0.941481 -3.12923 -3.02599 2.90572 +10 1 0.998541 -1.16996 1.42191 -2.76709 -0.0175982 4.85417 +11 2 0.970261 -1.63876 0.575717 2.4618 4.28015 -0.493825 +12 2 1.54742 -0.386783 1.27666 -1.41861 -3.70889 -3.67396 +13 1 0.969317 -1.3895 -1.32829 2.03562 -5.48364 0.295138 +14 2 0.0583035 -1.11723 -1.49206 1.73159 3.49229 -0.0543931 +15 2 1.50655 -0.600283 -1.19205 -3.9925 1.94925 -1.04523 +16 1 2.00848 1.05446 -0.124132 1.88868 -1.58075 0.754117 +17 2 1.16959 1.53865 -0.11771 0.573913 1.34283 -0.58573 +18 2 2.71517 1.69464 -0.239075 -2.32089 0.157967 0.209615 +ITEM: TIMESTEP +40 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.53726 -0.175397 1.46121 -7.56641 2.45844 -0.518817 +2 2 -0.675238 -0.584022 1.60915 7.85196 -3.99237 1.67217 +3 2 -2.08862 -0.402087 2.21789 3.0617 0.39778 -2.04562 +4 1 -1.73949 -0.379604 -1.32819 -2.36016 -0.787528 -0.0315325 +5 2 -1.83346 -0.428429 -0.37056 1.90026 0.717301 4.17358 +6 2 -2.53017 -0.786871 -1.68316 0.151557 -0.108901 -3.75615 +7 1 -0.576955 2.0043 -0.124416 -0.431513 -1.54355 -1.46354 +8 2 -0.992092 1.48382 0.567817 1.09284 0.418387 6.78235 +9 2 -0.944746 1.62819 -0.925975 0.76441 1.37882 -5.22407 +10 1 1.00941 -1.17308 1.4189 -1.85973 4.64458 1.0889 +11 2 0.973659 -1.6403 0.580693 -1.69219 -4.78957 -3.29195 +12 2 1.53559 -0.396477 1.19908 0.544307 1.46508 3.63166 +13 1 0.969009 -1.38744 -1.3228 -0.275569 1.85307 -0.63583 +14 2 0.0737932 -1.09141 -1.50366 -4.66851 -2.83882 -1.16892 +15 2 1.46633 -0.576681 -1.19175 5.00795 0.70617 0.521536 +16 1 2.01183 1.05054 -0.121932 4.41526 -1.70685 -0.0836272 +17 2 1.19121 1.55327 -0.120038 -7.25224 2.19125 0.154184 +18 2 2.71636 1.68982 -0.237383 1.31607 -0.463304 0.195666 +ITEM: TIMESTEP +50 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.53986 -0.172749 1.46865 -10.3641 5.96951 -4.41562 +2 2 -0.678724 -0.568486 1.60775 14.9207 -7.13278 2.04782 +3 2 -2.07217 -0.405364 2.23045 -0.725799 -0.490948 1.77161 +4 1 -1.74113 -0.378171 -1.32957 5.99712 2.85952 -9.13842 +5 2 -1.82713 -0.447378 -0.375703 -3.89226 -1.3818 7.11516 +6 2 -2.4999 -0.790471 -1.74187 -3.02333 -1.60416 1.77146 +7 1 -0.579496 1.99691 -0.128028 9.72738 10.7655 -0.463519 +8 2 -0.97832 1.50522 0.591572 -4.4866 -5.64841 2.33138 +9 2 -0.951447 1.66071 -0.944057 -3.97244 -4.92262 -1.79974 +10 1 1.01358 -1.17192 1.41393 -6.48605 2.83151 13.495 +11 2 0.960671 -1.668 0.598799 0.887838 -3.18341 -9.75086 +12 2 1.53449 -0.394669 1.19537 2.46945 2.14925 -1.89795 +13 1 0.966791 -1.38037 -1.31946 4.73561 -12.449 -1.17286 +14 2 0.0653014 -1.12956 -1.52441 -4.76491 5.51904 -0.304595 +15 2 1.48076 -0.580834 -1.19775 0.0522693 6.36707 0.249418 +16 1 2.01309 1.04924 -0.119438 7.79557 -11.0594 0.778107 +17 2 1.18753 1.53519 -0.124654 -9.57007 7.63584 -0.456674 +18 2 2.72824 1.67508 -0.226016 0.699647 3.77524 -0.159727 +ITEM: TIMESTEP +60 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.535 -0.173529 1.47468 -12.8115 9.37187 -10.8344 +2 2 -0.673508 -0.564245 1.59147 19.3914 -9.12777 2.73797 +3 2 -2.04099 -0.404174 2.24807 -3.82175 -1.70255 6.71674 +4 1 -1.73996 -0.376347 -1.33351 0.570165 0.280665 -6.43548 +5 2 -1.87928 -0.466718 -0.390362 1.26398 0.876645 10.7815 +6 2 -2.48657 -0.801116 -1.75201 -2.14828 -1.00411 -3.66812 +7 1 -0.576718 1.99595 -0.131852 3.14419 3.30092 -1.47913 +8 2 -0.97416 1.49195 0.577492 -1.32391 -2.58987 8.72867 +9 2 -0.983297 1.63168 -0.91691 -0.334419 -0.770035 -7.07098 +10 1 1.00791 -1.1681 1.41401 -6.20027 1.07549 12.575 +11 2 0.972875 -1.65454 0.593802 -0.476084 -5.46772 -10.3478 +12 2 1.54632 -0.404877 1.20306 3.83119 5.88484 -0.834958 +13 1 0.966385 -1.38017 -1.32091 1.49436 -4.60495 -1.57148 +14 2 0.0722824 -1.10128 -1.51274 -8.16812 -0.531008 -1.13308 +15 2 1.45394 -0.565765 -1.20718 7.01226 4.42564 1.66198 +16 1 2.01308 1.04537 -0.116618 6.94232 -7.944 0.350248 +17 2 1.19126 1.53332 -0.135036 -13.3157 5.74475 0.221956 +18 2 2.70715 1.69348 -0.205764 4.95008 2.7812 -0.398561 +ITEM: TIMESTEP +70 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.52447 -0.177745 1.47754 -14.009 12.5988 -14.9127 +2 2 -0.663619 -0.56979 1.57126 20.9018 -10.2143 3.8986 +3 2 -2.00537 -0.388653 2.26816 -5.41735 -2.91391 10.0958 +4 1 -1.74327 -0.377755 -1.33511 7.69657 4.1782 -9.73798 +5 2 -1.88018 -0.439682 -0.388162 -4.07322 -2.33918 9.17346 +6 2 -2.47021 -0.801057 -1.79014 -4.11028 -2.07522 1.70143 +7 1 -0.576352 1.99233 -0.135801 8.33914 8.33997 -1.40304 +8 2 -0.93279 1.50467 0.607511 -5.01196 -5.05095 3.69276 +9 2 -0.967697 1.61396 -0.924499 -2.96791 -3.60448 -2.11522 +10 1 0.996682 -1.16249 1.41603 -5.52393 -2.7768 9.00886 +11 2 0.982553 -1.62276 0.577115 -1.00274 -4.80219 -7.71302 +12 2 1.55168 -0.404501 1.24312 4.97383 8.09577 -0.603791 +13 1 0.964232 -1.37715 -1.32734 3.83388 -12.0598 -0.0980446 +14 2 0.0575072 -1.10802 -1.48098 -4.628 4.85469 -1.01689 +15 2 1.48931 -0.58697 -1.19891 1.1914 7.02562 -0.119366 +16 1 2.01083 1.04528 -0.114231 6.83173 -12.9986 1.26494 +17 2 1.17034 1.50303 -0.133551 -9.79274 8.34256 -0.476042 +18 2 2.7022 1.69874 -0.182183 2.76884 5.3999 -0.639748 +ITEM: TIMESTEP +80 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.51177 -0.182537 1.47592 -13.1365 10.3139 -11.8951 +2 2 -0.654143 -0.583091 1.57918 18.6975 -8.17701 1.44433 +3 2 -1.97348 -0.365352 2.2852 -6.58467 -1.56222 9.05296 +4 1 -1.74352 -0.377279 -1.33693 -0.505822 0.308788 -3.25308 +5 2 -1.91188 -0.438855 -0.39405 1.95743 0.358158 9.20234 +6 2 -2.48397 -0.807922 -1.76244 -1.16931 -0.70018 -3.86005 +7 1 -0.571778 1.99034 -0.138544 1.3921 0.315501 -1.43854 +8 2 -0.938419 1.50232 0.602337 -1.22478 -1.30903 4.8686 +9 2 -0.959599 1.56918 -0.90914 -0.0288155 0.574454 -3.52808 +10 1 0.985435 -1.15713 1.41811 -6.25848 -6.25702 9.27302 +11 2 0.972167 -1.59168 0.560031 1.69554 -0.201305 -5.06875 +12 2 1.54032 -0.386652 1.30283 4.96928 5.72762 -4.15176 +13 1 0.963614 -1.3793 -1.33436 0.183354 -1.1048 0.823621 +14 2 0.065336 -1.06423 -1.45856 -4.4409 -1.33366 -2.05511 +15 2 1.49256 -0.587857 -1.21654 4.36346 2.23441 0.338535 +16 1 2.00803 1.04345 -0.110717 3.61274 -3.25471 0.639326 +17 2 1.16919 1.51061 -0.133404 -8.46417 2.50048 0.10369 +18 2 2.67828 1.72068 -0.16597 4.94198 1.56662 -0.49597 +ITEM: TIMESTEP +90 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.50159 -0.186388 1.47232 -10.1666 8.56134 -9.06842 +2 2 -0.637201 -0.589948 1.58141 9.00709 -5.13609 3.43504 +3 2 -1.97805 -0.327506 2.28752 -1.76215 -2.05269 5.01359 +4 1 -1.7485 -0.377921 -1.33249 5.81313 3.27044 -5.4853 +5 2 -1.87141 -0.433051 -0.37781 -3.50795 -2.5324 4.09176 +6 2 -2.48522 -0.804273 -1.77362 -2.18894 -1.0456 2.79096 +7 1 -0.568425 1.98378 -0.140489 1.33268 1.60885 -0.760228 +8 2 -0.945484 1.51375 0.61188 -1.03442 -1.79649 -0.570033 +9 2 -0.936389 1.56212 -0.924193 -1.07342 -0.200973 1.02154 +10 1 0.975854 -1.15481 1.42351 1.86741 -2.52595 -4.21318 +11 2 0.98193 -1.53917 0.537259 -2.6087 -4.02599 1.03016 +12 2 1.52752 -0.379325 1.30866 2.98513 5.11632 2.51897 +13 1 0.962056 -1.37771 -1.33914 1.58342 -3.36145 0.893222 +14 2 0.0608833 -1.06855 -1.4877 0.530861 1.7595 -0.414339 +15 2 1.52774 -0.603203 -1.25083 -2.15602 1.98356 -0.537593 +16 1 2.00483 1.04652 -0.10624 2.44039 -5.05754 0.604689 +17 2 1.15126 1.49959 -0.126569 -0.261743 3.34267 -0.115684 +18 2 2.69252 1.71134 -0.15978 -0.800158 2.09248 -0.235157 +ITEM: TIMESTEP +100 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.49915 -0.184572 1.46491 -1.64286 -0.923423 4.11541 +2 2 -0.634606 -0.601439 1.61658 -0.503947 1.48506 -2.91046 +3 2 -1.9835 -0.312527 2.28463 -1.23961 0.673264 -1.96712 +4 1 -1.74898 -0.375873 -1.32741 -4.05983 -3.09974 1.92324 +5 2 -1.86884 -0.471305 -0.372769 3.24632 2.33491 1.76011 +6 2 -2.50916 -0.806172 -1.72327 1.14638 0.924599 -3.12385 +7 1 -0.564884 1.97778 -0.142101 -4.14881 -3.0738 -0.168062 +8 2 -0.958996 1.4911 0.595477 2.25574 1.20147 -1.85844 +9 2 -0.937749 1.56372 -0.930264 1.31445 2.00952 1.76263 +10 1 0.975211 -1.15256 1.42364 -0.947501 -4.6035 2.62584 +11 2 0.950951 -1.55837 0.541757 3.10583 4.89391 1.85772 +12 2 1.52342 -0.363228 1.34082 0.672959 -1.69053 -5.30235 +13 1 0.962361 -1.37851 -1.34242 -1.40487 6.54708 -1.50719 +14 2 0.0703818 -1.05861 -1.53269 1.44041 -3.14031 1.12109 +15 2 1.51335 -0.586474 -1.29057 -0.612624 -3.69916 1.63647 +16 1 2.00445 1.04687 -0.100669 -1.02523 8.04786 -0.336895 +17 2 1.16075 1.52969 -0.119062 2.24423 -4.67525 0.190963 +18 2 2.68635 1.72058 -0.160395 0.158945 -3.21195 0.180894 diff --git a/examples/amoeba/dump.water_hexamer.hippo.1.test b/examples/amoeba/dump.water_hexamer.hippo.1.test new file mode 100644 index 0000000000..a808eb88d8 --- /dev/null +++ b/examples/amoeba/dump.water_hexamer.hippo.1.test @@ -0,0 +1,297 @@ +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.50217 -0.191359 1.43493 19.9357 -10.2022 6.39617 +2 2 -0.601054 -0.596972 1.55372 -26.7746 11.7551 -3.2269 +3 2 -2.0067 -0.422327 2.21985 2.27453 0.843475 -3.26617 +4 1 -1.74457 -0.382348 -1.30914 -7.45906 -3.26138 10.4208 +5 2 -1.88894 -0.479653 -0.347624 4.39096 1.86538 -10.993 +6 2 -2.51683 -0.766765 -1.73377 3.97889 2.0308 0.238005 +7 1 -0.560409 2.01783 -0.121984 -15.0354 -12.151 1.41176 +8 2 -0.94772 1.53357 0.625228 7.62359 5.98784 -1.89388 +9 2 -0.989831 1.59274 -0.877419 6.55934 4.96076 0.527359 +10 1 0.964803 -1.16576 1.43999 15.4285 1.35636 -21.3173 +11 2 0.979557 -1.52204 0.527833 -6.23862 0.631634 14.3987 +12 2 1.54222 -0.393692 1.34437 -5.98579 -2.68738 6.2337 +13 1 0.974705 -1.4015 -1.33597 -5.70279 13.9492 -3.53962 +14 2 0.065161 -1.11895 -1.52289 5.16041 -6.4649 2.71211 +15 2 1.47071 -0.570933 -1.27771 0.726496 -6.9774 1.88925 +16 1 2.00228 1.05782 -0.124502 -11.1831 12.6873 -1.41281 +17 2 1.14164 1.53227 -0.140121 14.1175 -10.0366 0.774885 +18 2 2.67472 1.73534 -0.237995 -1.81661 -4.28693 0.646829 +ITEM: TIMESTEP +10 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.50519 -0.189085 1.43489 16.1346 -9.03082 7.39643 +2 2 -0.613325 -0.596599 1.55623 -19.7 9.16793 -3.06694 +3 2 -2.00781 -0.423676 2.21968 1.11569 1.33017 -3.51515 +4 1 -1.74545 -0.38218 -1.30921 -0.873137 -0.924011 5.81502 +5 2 -1.86379 -0.472478 -0.34573 -0.592473 0.521176 -9.80595 +6 2 -2.51308 -0.764814 -1.7423 1.95383 0.883641 3.34899 +7 1 -0.566746 2.01551 -0.121884 -0.752908 0.880358 1.51675 +8 2 -0.90288 1.53899 0.653422 -0.370038 -0.282546 -8.72932 +9 2 -0.948386 1.59852 -0.906373 -0.161598 -1.83495 7.27882 +10 1 0.972994 -1.16632 1.4367 2.1365 -3.63541 -4.30666 +11 2 0.921471 -1.54563 0.536978 3.92948 8.96444 9.02535 +12 2 1.51571 -0.366599 1.37318 -3.05971 -5.7155 -5.67471 +13 1 0.973913 -1.39785 -1.33834 -1.44621 0.344209 -0.720777 +14 2 0.0503221 -1.15099 -1.50181 7.085 2.52089 1.36272 +15 2 1.49605 -0.587274 -1.24124 -6.30793 -2.23617 0.0453877 +16 1 2.00301 1.05777 -0.1249 -8.37521 5.68727 -0.0787125 +17 2 1.13805 1.51682 -0.135757 12.8554 -4.94557 -0.27859 +18 2 2.68412 1.72611 -0.2366 -3.57128 -1.69512 0.387339 +ITEM: TIMESTEP +20 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.51053 -0.184679 1.43662 2.59225 -2.34383 2.4228 +2 2 -0.638864 -0.59446 1.56144 -3.81751 1.45077 0.169365 +3 2 -2.02892 -0.415768 2.21112 1.3915 0.960529 -2.2268 +4 1 -1.7422 -0.380161 -1.31156 -2.81538 -1.6524 5.61723 +5 2 -1.87085 -0.467579 -0.355121 2.06181 1.26201 -3.01668 +6 2 -2.51909 -0.769609 -1.71571 1.56589 0.868196 -2.04346 +7 1 -0.571857 2.01726 -0.121524 -4.42229 -10.7497 0.101549 +8 2 -0.894989 1.49275 0.621756 1.9428 5.13739 2.3456 +9 2 -0.928333 1.53949 -0.878364 1.74391 4.55343 -2.63937 +10 1 0.983665 -1.17004 1.43811 2.15858 5.32924 -12.0192 +11 2 0.916986 -1.51176 0.532863 -0.801958 -4.34579 6.00669 +12 2 1.48632 -0.356933 1.30471 -0.115562 -1.35756 5.38685 +13 1 0.974155 -1.39809 -1.34091 -3.6872 9.81415 2.33229 +14 2 0.0608639 -1.11508 -1.47548 0.727822 -4.45373 -1.43277 +15 2 1.45945 -0.57705 -1.18377 2.74992 -3.83937 -1.32423 +16 1 2.0041 1.05318 -0.12468 -4.82863 5.07797 -0.287867 +17 2 1.15863 1.52924 -0.140109 2.7798 -3.05413 0.358119 +18 2 2.67895 1.72504 -0.234758 0.77424 -2.65718 0.249897 +ITEM: TIMESTEP +30 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.5148 -0.180382 1.43888 -14.0787 7.25927 -2.0787 +2 2 -0.670243 -0.596746 1.58256 15.1847 -7.27642 2.26385 +3 2 -2.0578 -0.394757 2.19803 0.335566 -0.184039 0.277588 +4 1 -1.73953 -0.378972 -1.31065 5.17639 2.63373 -5.13987 +5 2 -1.85923 -0.443728 -0.358889 -2.57415 -1.51426 3.86387 +6 2 -2.50599 -0.762479 -1.73443 -2.25678 -0.997735 0.886673 +7 1 -0.57869 2.00716 -0.122116 7.46708 7.5609 -0.932554 +8 2 -0.891326 1.5227 0.646189 -3.77932 -4.24552 -0.379656 +9 2 -0.906489 1.54888 -0.899539 -3.74504 -3.89196 0.775918 +10 1 0.993915 -1.16716 1.4314 -4.03671 -0.827424 10.5116 +11 2 0.932938 -1.58361 0.567361 1.80347 1.36047 -5.88474 +12 2 1.49414 -0.355801 1.3027 1.34198 0.116597 -4.03649 +13 1 0.970608 -1.38983 -1.33905 4.21477 -7.05635 0.421831 +14 2 0.0575618 -1.13428 -1.49637 -1.45416 4.35852 0.0411765 +15 2 1.48422 -0.594211 -1.16216 -2.77696 3.0816 -1.11496 +16 1 2.00096 1.05017 -0.124007 4.94447 -7.97826 1.06585 +17 2 1.17138 1.53183 -0.140668 -5.63771 5.40691 -0.274313 +18 2 2.7082 1.68479 -0.23083 -0.128954 2.19398 -0.267092 +ITEM: TIMESTEP +40 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.5186 -0.17605 1.44225 -24.1552 14.2056 -8.76949 +2 2 -0.687962 -0.594151 1.59127 27.1026 -13.0552 4.45143 +3 2 -2.07116 -0.378379 2.19317 -1.29427 -1.5252 3.96365 +4 1 -1.73305 -0.375414 -1.31137 2.16372 2.0419 -7.75161 +5 2 -1.87951 -0.450834 -0.370226 0.624847 -0.775772 11.2387 +6 2 -2.50254 -0.754697 -1.72909 -2.50645 -1.07375 -3.54713 +7 1 -0.578876 1.99941 -0.124067 2.19183 2.88771 -2.2033 +8 2 -0.936478 1.52242 0.623048 -0.431918 -2.06784 8.93732 +9 2 -0.943689 1.52907 -0.872983 -0.503357 -0.655131 -7.36871 +10 1 1.00066 -1.16525 1.43041 -2.12968 1.37125 11.5778 +11 2 0.974279 -1.60078 0.583019 -3.02955 -6.45349 -11.2722 +12 2 1.51087 -0.375422 1.25067 2.49642 6.22795 1.24643 +13 1 0.96952 -1.38626 -1.33641 3.1199 -1.09706 -1.06644 +14 2 0.0736705 -1.0998 -1.50988 -8.20047 -1.85824 -0.95018 +15 2 1.45433 -0.57243 -1.18601 5.63783 2.37426 1.20997 +16 1 1.9962 1.04317 -0.122075 10.6231 -9.89832 0.540427 +17 2 1.19663 1.55837 -0.138658 -15.3708 7.22601 0.146924 +18 2 2.71508 1.6609 -0.228386 3.66149 2.12531 -0.383549 +ITEM: TIMESTEP +50 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.52326 -0.171807 1.44556 -19.3809 13.2253 -10.6114 +2 2 -0.679923 -0.574818 1.57581 25.4624 -12.0419 4.4477 +3 2 -2.05017 -0.382025 2.20867 -3.53537 -2.33472 6.62258 +4 1 -1.72947 -0.37135 -1.31158 7.45117 4.03521 -12.7525 +5 2 -1.85272 -0.46757 -0.370426 -4.08312 -1.86842 12.0545 +6 2 -2.4914 -0.737252 -1.75485 -4.03109 -2.01148 0.403261 +7 1 -0.581812 1.98886 -0.127591 8.73336 12.0451 -2.23223 +8 2 -0.927295 1.54015 0.641551 -4.26906 -6.45964 5.24049 +9 2 -0.953055 1.5416 -0.887204 -3.28906 -5.2042 -3.24355 +10 1 1.00866 -1.16393 1.43094 -5.76797 0.688141 16.3003 +11 2 0.941718 -1.59751 0.586621 -0.69625 -5.79697 -13.9615 +12 2 1.5005 -0.365594 1.24465 4.16474 6.46538 -1.29083 +13 1 0.968591 -1.37822 -1.33754 5.88173 -13.6635 -0.995409 +14 2 0.058765 -1.13465 -1.50083 -6.65826 5.43105 -0.991523 +15 2 1.47128 -0.574689 -1.20309 0.663977 7.53437 1.14922 +16 1 1.99172 1.03702 -0.120004 11.7209 -15.9347 1.25003 +17 2 1.18616 1.54124 -0.127765 -14.4197 10.6401 -0.950727 +18 2 2.7224 1.64022 -0.223578 2.05256 5.25094 -0.438473 +ITEM: TIMESTEP +60 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.52514 -0.169424 1.44931 -5.6044 5.71407 -7.65735 +2 2 -0.654856 -0.548823 1.55951 12.8877 -6.19997 1.70589 +3 2 -2.01089 -0.399975 2.23335 -4.71544 -1.47688 6.26364 +4 1 -1.72371 -0.366036 -1.3145 0.154709 0.0103655 -5.79078 +5 2 -1.86537 -0.486382 -0.375504 0.204748 0.738589 9.60402 +6 2 -2.49691 -0.728317 -1.74343 -1.12209 -0.453095 -3.27306 +7 1 -0.582396 1.98478 -0.131637 3.0799 3.10149 -1.36944 +8 2 -0.917703 1.51358 0.63199 -1.67497 -1.52591 5.69623 +9 2 -0.95935 1.51373 -0.876424 -0.704912 -1.0485 -4.50039 +10 1 1.01141 -1.16147 1.43332 -7.40944 0.284109 12.5023 +11 2 0.911102 -1.56686 0.573359 1.73368 -3.47737 -10.1102 +12 2 1.49548 -0.352196 1.26684 4.34342 4.22027 -2.29553 +13 1 0.969684 -1.37685 -1.34222 -0.51092 -4.11589 -0.224969 +14 2 0.0587056 -1.1173 -1.48363 -6.15339 -0.904158 -2.27293 +15 2 1.44029 -0.555019 -1.20354 6.44357 4.32801 1.75924 +16 1 1.98854 1.02727 -0.117121 5.38674 -4.81439 0.472007 +17 2 1.17286 1.52668 -0.137432 -10.3716 4.01885 -0.196355 +18 2 2.69 1.66639 -0.213741 4.03261 1.60042 -0.312306 +ITEM: TIMESTEP +70 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.52005 -0.170765 1.45435 7.42813 -0.682132 -3.31568 +2 2 -0.627795 -0.545781 1.54703 -4.484 0.351316 0.767932 +3 2 -1.9938 -0.405389 2.24937 -1.65789 -0.838399 2.61041 +4 1 -1.72181 -0.363627 -1.31513 2.63115 1.26887 -2.8752 +5 2 -1.86247 -0.45623 -0.365408 -2.65258 -1.1368 1.02525 +6 2 -2.4895 -0.712321 -1.77001 -0.898587 -0.369019 2.21573 +7 1 -0.583063 1.97962 -0.135858 1.67055 0.570004 -0.383383 +8 2 -0.908051 1.51128 0.64094 -1.16679 -0.0785678 -0.520586 +9 2 -0.943124 1.49995 -0.888932 -0.754685 -0.199723 0.596245 +10 1 1.00431 -1.15529 1.43647 -0.676345 0.911353 -2.95012 +11 2 0.95109 -1.53365 0.551095 -1.85378 -3.64627 0.0738184 +12 2 1.52689 -0.36229 1.29214 1.34973 2.90443 2.73267 +13 1 0.96764 -1.3732 -1.34735 0.830518 -7.82237 0.0710001 +14 2 0.049796 -1.13062 -1.50565 0.0671147 3.17314 0.120857 +15 2 1.46341 -0.566541 -1.18509 -0.178936 4.65822 -0.507667 +16 1 1.98438 1.02188 -0.114233 -0.881295 -2.57322 0.275288 +17 2 1.13419 1.48172 -0.149659 1.87909 1.86036 0.463365 +18 2 2.6735 1.67987 -0.202074 -0.651386 1.64881 -0.399918 +ITEM: TIMESTEP +80 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.50978 -0.173017 1.45833 15.0482 -9.57345 5.77126 +2 2 -0.617503 -0.581602 1.56045 -17.3455 8.85736 -2.90765 +3 2 -1.99215 -0.403845 2.25671 0.833211 1.42908 -3.53001 +4 1 -1.71857 -0.360372 -1.31644 -7.32338 -2.11362 6.45601 +5 2 -1.89982 -0.440583 -0.365391 4.39327 0.727605 -4.87947 +6 2 -2.49827 -0.701359 -1.75982 2.51785 1.20426 -1.18541 +7 1 -0.581108 1.97455 -0.140769 -3.87733 -3.80002 1.10694 +8 2 -0.928789 1.51932 0.641149 2.19408 2.20718 -5.07369 +9 2 -0.943839 1.48954 -0.89443 1.32563 2.05291 3.72773 +10 1 0.995847 -1.14613 1.43537 0.755936 -5.6909 -0.46639 +11 2 0.966841 -1.55186 0.550806 1.56938 7.42451 5.54707 +12 2 1.55511 -0.362342 1.35836 -2.79165 -2.9995 -5.36768 +13 1 0.967816 -1.37465 -1.35163 -3.29308 4.65803 -0.872226 +14 2 0.0602027 -1.09254 -1.5264 2.56737 -3.64929 1.27094 +15 2 1.45854 -0.559392 -1.19328 1.84002 -1.84978 0.0538636 +16 1 1.98052 1.0158 -0.111184 -7.14388 11.5516 -0.816233 +17 2 1.12003 1.47724 -0.140032 8.70268 -6.85942 1.26876 +18 2 2.64114 1.706 -0.201685 0.0272078 -3.57662 -0.103793 +ITEM: TIMESTEP +90 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.50003 -0.175917 1.46165 15.3898 -11.884 8.8546 +2 2 -0.608584 -0.600731 1.57129 -23.7815 11.9323 -1.75151 +3 2 -2.00991 -0.394435 2.25305 5.57059 1.55514 -7.64598 +4 1 -1.72137 -0.357368 -1.31563 -1.93902 -0.246344 7.85181 +5 2 -1.87234 -0.43987 -0.353482 -0.118832 -0.772284 -11.4834 +6 2 -2.49861 -0.682857 -1.77755 1.48512 0.513779 4.12935 +7 1 -0.579472 1.97061 -0.145894 -8.85759 -8.26094 2.77276 +8 2 -0.945449 1.52054 0.635243 4.66427 4.57627 -6.94972 +9 2 -0.952686 1.48464 -0.897126 3.60343 4.09955 4.74753 +10 1 0.988258 -1.14419 1.44127 11.1074 1.88534 -20.9154 +11 2 0.971991 -1.50516 0.531218 -4.29535 0.162687 14.3489 +12 2 1.5415 -0.356231 1.32305 -5.76468 -4.25266 5.91571 +13 1 0.969416 -1.37359 -1.35605 -1.23717 3.53556 0.174563 +14 2 0.053578 -1.1004 -1.52114 7.10928 -0.236326 1.96556 +15 2 1.49219 -0.569722 -1.21186 -5.0738 -3.24139 -1.5161 +16 1 1.97824 1.01566 -0.108279 -8.95647 8.69277 0.191958 +17 2 1.10027 1.45664 -0.104435 15.9218 -5.21388 -1.22481 +18 2 2.64464 1.70165 -0.21558 -4.82724 -2.84557 0.534172 +ITEM: TIMESTEP +100 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.4951 -0.17739 1.46185 11.6291 -12.0775 13.5087 +2 2 -0.608426 -0.588808 1.60852 -19.0988 9.4339 -4.86631 +3 2 -2.01619 -0.397996 2.24676 4.77562 3.06476 -9.1756 +4 1 -1.72287 -0.352149 -1.31567 -8.10325 -4.84048 12.8242 +5 2 -1.86729 -0.479262 -0.356777 4.49726 3.58866 -11.0242 +6 2 -2.51926 -0.676876 -1.74282 3.42966 1.20159 -1.20299 +7 1 -0.581355 1.96754 -0.149521 -5.24612 -4.66563 2.71982 +8 2 -0.935394 1.51644 0.636953 2.89489 2.96603 -9.31226 +9 2 -0.942573 1.488 -0.91114 1.96254 2.34604 7.29302 +10 1 0.988651 -1.14425 1.44045 0.840008 -1.36718 -7.83612 +11 2 0.899639 -1.53136 0.543246 5.64911 9.69241 11.7913 +12 2 1.49178 -0.318235 1.33897 -3.7582 -9.86315 -4.79205 +13 1 0.974233 -1.37573 -1.35945 -3.77942 11.331 0.435153 +14 2 0.0583408 -1.08758 -1.49668 6.15796 -3.89994 -0.197074 +15 2 1.48764 -0.558876 -1.24121 -3.14566 -8.24544 0.525665 +16 1 1.97883 1.01496 -0.10404 -9.03485 15.6667 -0.929518 +17 2 1.11471 1.47883 -0.106249 11.9101 -8.77208 -0.858699 +18 2 2.63671 1.70526 -0.232286 -1.57994 -5.55972 1.09694 diff --git a/examples/amoeba/dump.water_hexamer.hippo.4.test b/examples/amoeba/dump.water_hexamer.hippo.4.test new file mode 100644 index 0000000000..a808eb88d8 --- /dev/null +++ b/examples/amoeba/dump.water_hexamer.hippo.4.test @@ -0,0 +1,297 @@ +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.50217 -0.191359 1.43493 19.9357 -10.2022 6.39617 +2 2 -0.601054 -0.596972 1.55372 -26.7746 11.7551 -3.2269 +3 2 -2.0067 -0.422327 2.21985 2.27453 0.843475 -3.26617 +4 1 -1.74457 -0.382348 -1.30914 -7.45906 -3.26138 10.4208 +5 2 -1.88894 -0.479653 -0.347624 4.39096 1.86538 -10.993 +6 2 -2.51683 -0.766765 -1.73377 3.97889 2.0308 0.238005 +7 1 -0.560409 2.01783 -0.121984 -15.0354 -12.151 1.41176 +8 2 -0.94772 1.53357 0.625228 7.62359 5.98784 -1.89388 +9 2 -0.989831 1.59274 -0.877419 6.55934 4.96076 0.527359 +10 1 0.964803 -1.16576 1.43999 15.4285 1.35636 -21.3173 +11 2 0.979557 -1.52204 0.527833 -6.23862 0.631634 14.3987 +12 2 1.54222 -0.393692 1.34437 -5.98579 -2.68738 6.2337 +13 1 0.974705 -1.4015 -1.33597 -5.70279 13.9492 -3.53962 +14 2 0.065161 -1.11895 -1.52289 5.16041 -6.4649 2.71211 +15 2 1.47071 -0.570933 -1.27771 0.726496 -6.9774 1.88925 +16 1 2.00228 1.05782 -0.124502 -11.1831 12.6873 -1.41281 +17 2 1.14164 1.53227 -0.140121 14.1175 -10.0366 0.774885 +18 2 2.67472 1.73534 -0.237995 -1.81661 -4.28693 0.646829 +ITEM: TIMESTEP +10 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.50519 -0.189085 1.43489 16.1346 -9.03082 7.39643 +2 2 -0.613325 -0.596599 1.55623 -19.7 9.16793 -3.06694 +3 2 -2.00781 -0.423676 2.21968 1.11569 1.33017 -3.51515 +4 1 -1.74545 -0.38218 -1.30921 -0.873137 -0.924011 5.81502 +5 2 -1.86379 -0.472478 -0.34573 -0.592473 0.521176 -9.80595 +6 2 -2.51308 -0.764814 -1.7423 1.95383 0.883641 3.34899 +7 1 -0.566746 2.01551 -0.121884 -0.752908 0.880358 1.51675 +8 2 -0.90288 1.53899 0.653422 -0.370038 -0.282546 -8.72932 +9 2 -0.948386 1.59852 -0.906373 -0.161598 -1.83495 7.27882 +10 1 0.972994 -1.16632 1.4367 2.1365 -3.63541 -4.30666 +11 2 0.921471 -1.54563 0.536978 3.92948 8.96444 9.02535 +12 2 1.51571 -0.366599 1.37318 -3.05971 -5.7155 -5.67471 +13 1 0.973913 -1.39785 -1.33834 -1.44621 0.344209 -0.720777 +14 2 0.0503221 -1.15099 -1.50181 7.085 2.52089 1.36272 +15 2 1.49605 -0.587274 -1.24124 -6.30793 -2.23617 0.0453877 +16 1 2.00301 1.05777 -0.1249 -8.37521 5.68727 -0.0787125 +17 2 1.13805 1.51682 -0.135757 12.8554 -4.94557 -0.27859 +18 2 2.68412 1.72611 -0.2366 -3.57128 -1.69512 0.387339 +ITEM: TIMESTEP +20 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.51053 -0.184679 1.43662 2.59225 -2.34383 2.4228 +2 2 -0.638864 -0.59446 1.56144 -3.81751 1.45077 0.169365 +3 2 -2.02892 -0.415768 2.21112 1.3915 0.960529 -2.2268 +4 1 -1.7422 -0.380161 -1.31156 -2.81538 -1.6524 5.61723 +5 2 -1.87085 -0.467579 -0.355121 2.06181 1.26201 -3.01668 +6 2 -2.51909 -0.769609 -1.71571 1.56589 0.868196 -2.04346 +7 1 -0.571857 2.01726 -0.121524 -4.42229 -10.7497 0.101549 +8 2 -0.894989 1.49275 0.621756 1.9428 5.13739 2.3456 +9 2 -0.928333 1.53949 -0.878364 1.74391 4.55343 -2.63937 +10 1 0.983665 -1.17004 1.43811 2.15858 5.32924 -12.0192 +11 2 0.916986 -1.51176 0.532863 -0.801958 -4.34579 6.00669 +12 2 1.48632 -0.356933 1.30471 -0.115562 -1.35756 5.38685 +13 1 0.974155 -1.39809 -1.34091 -3.6872 9.81415 2.33229 +14 2 0.0608639 -1.11508 -1.47548 0.727822 -4.45373 -1.43277 +15 2 1.45945 -0.57705 -1.18377 2.74992 -3.83937 -1.32423 +16 1 2.0041 1.05318 -0.12468 -4.82863 5.07797 -0.287867 +17 2 1.15863 1.52924 -0.140109 2.7798 -3.05413 0.358119 +18 2 2.67895 1.72504 -0.234758 0.77424 -2.65718 0.249897 +ITEM: TIMESTEP +30 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.5148 -0.180382 1.43888 -14.0787 7.25927 -2.0787 +2 2 -0.670243 -0.596746 1.58256 15.1847 -7.27642 2.26385 +3 2 -2.0578 -0.394757 2.19803 0.335566 -0.184039 0.277588 +4 1 -1.73953 -0.378972 -1.31065 5.17639 2.63373 -5.13987 +5 2 -1.85923 -0.443728 -0.358889 -2.57415 -1.51426 3.86387 +6 2 -2.50599 -0.762479 -1.73443 -2.25678 -0.997735 0.886673 +7 1 -0.57869 2.00716 -0.122116 7.46708 7.5609 -0.932554 +8 2 -0.891326 1.5227 0.646189 -3.77932 -4.24552 -0.379656 +9 2 -0.906489 1.54888 -0.899539 -3.74504 -3.89196 0.775918 +10 1 0.993915 -1.16716 1.4314 -4.03671 -0.827424 10.5116 +11 2 0.932938 -1.58361 0.567361 1.80347 1.36047 -5.88474 +12 2 1.49414 -0.355801 1.3027 1.34198 0.116597 -4.03649 +13 1 0.970608 -1.38983 -1.33905 4.21477 -7.05635 0.421831 +14 2 0.0575618 -1.13428 -1.49637 -1.45416 4.35852 0.0411765 +15 2 1.48422 -0.594211 -1.16216 -2.77696 3.0816 -1.11496 +16 1 2.00096 1.05017 -0.124007 4.94447 -7.97826 1.06585 +17 2 1.17138 1.53183 -0.140668 -5.63771 5.40691 -0.274313 +18 2 2.7082 1.68479 -0.23083 -0.128954 2.19398 -0.267092 +ITEM: TIMESTEP +40 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.5186 -0.17605 1.44225 -24.1552 14.2056 -8.76949 +2 2 -0.687962 -0.594151 1.59127 27.1026 -13.0552 4.45143 +3 2 -2.07116 -0.378379 2.19317 -1.29427 -1.5252 3.96365 +4 1 -1.73305 -0.375414 -1.31137 2.16372 2.0419 -7.75161 +5 2 -1.87951 -0.450834 -0.370226 0.624847 -0.775772 11.2387 +6 2 -2.50254 -0.754697 -1.72909 -2.50645 -1.07375 -3.54713 +7 1 -0.578876 1.99941 -0.124067 2.19183 2.88771 -2.2033 +8 2 -0.936478 1.52242 0.623048 -0.431918 -2.06784 8.93732 +9 2 -0.943689 1.52907 -0.872983 -0.503357 -0.655131 -7.36871 +10 1 1.00066 -1.16525 1.43041 -2.12968 1.37125 11.5778 +11 2 0.974279 -1.60078 0.583019 -3.02955 -6.45349 -11.2722 +12 2 1.51087 -0.375422 1.25067 2.49642 6.22795 1.24643 +13 1 0.96952 -1.38626 -1.33641 3.1199 -1.09706 -1.06644 +14 2 0.0736705 -1.0998 -1.50988 -8.20047 -1.85824 -0.95018 +15 2 1.45433 -0.57243 -1.18601 5.63783 2.37426 1.20997 +16 1 1.9962 1.04317 -0.122075 10.6231 -9.89832 0.540427 +17 2 1.19663 1.55837 -0.138658 -15.3708 7.22601 0.146924 +18 2 2.71508 1.6609 -0.228386 3.66149 2.12531 -0.383549 +ITEM: TIMESTEP +50 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.52326 -0.171807 1.44556 -19.3809 13.2253 -10.6114 +2 2 -0.679923 -0.574818 1.57581 25.4624 -12.0419 4.4477 +3 2 -2.05017 -0.382025 2.20867 -3.53537 -2.33472 6.62258 +4 1 -1.72947 -0.37135 -1.31158 7.45117 4.03521 -12.7525 +5 2 -1.85272 -0.46757 -0.370426 -4.08312 -1.86842 12.0545 +6 2 -2.4914 -0.737252 -1.75485 -4.03109 -2.01148 0.403261 +7 1 -0.581812 1.98886 -0.127591 8.73336 12.0451 -2.23223 +8 2 -0.927295 1.54015 0.641551 -4.26906 -6.45964 5.24049 +9 2 -0.953055 1.5416 -0.887204 -3.28906 -5.2042 -3.24355 +10 1 1.00866 -1.16393 1.43094 -5.76797 0.688141 16.3003 +11 2 0.941718 -1.59751 0.586621 -0.69625 -5.79697 -13.9615 +12 2 1.5005 -0.365594 1.24465 4.16474 6.46538 -1.29083 +13 1 0.968591 -1.37822 -1.33754 5.88173 -13.6635 -0.995409 +14 2 0.058765 -1.13465 -1.50083 -6.65826 5.43105 -0.991523 +15 2 1.47128 -0.574689 -1.20309 0.663977 7.53437 1.14922 +16 1 1.99172 1.03702 -0.120004 11.7209 -15.9347 1.25003 +17 2 1.18616 1.54124 -0.127765 -14.4197 10.6401 -0.950727 +18 2 2.7224 1.64022 -0.223578 2.05256 5.25094 -0.438473 +ITEM: TIMESTEP +60 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.52514 -0.169424 1.44931 -5.6044 5.71407 -7.65735 +2 2 -0.654856 -0.548823 1.55951 12.8877 -6.19997 1.70589 +3 2 -2.01089 -0.399975 2.23335 -4.71544 -1.47688 6.26364 +4 1 -1.72371 -0.366036 -1.3145 0.154709 0.0103655 -5.79078 +5 2 -1.86537 -0.486382 -0.375504 0.204748 0.738589 9.60402 +6 2 -2.49691 -0.728317 -1.74343 -1.12209 -0.453095 -3.27306 +7 1 -0.582396 1.98478 -0.131637 3.0799 3.10149 -1.36944 +8 2 -0.917703 1.51358 0.63199 -1.67497 -1.52591 5.69623 +9 2 -0.95935 1.51373 -0.876424 -0.704912 -1.0485 -4.50039 +10 1 1.01141 -1.16147 1.43332 -7.40944 0.284109 12.5023 +11 2 0.911102 -1.56686 0.573359 1.73368 -3.47737 -10.1102 +12 2 1.49548 -0.352196 1.26684 4.34342 4.22027 -2.29553 +13 1 0.969684 -1.37685 -1.34222 -0.51092 -4.11589 -0.224969 +14 2 0.0587056 -1.1173 -1.48363 -6.15339 -0.904158 -2.27293 +15 2 1.44029 -0.555019 -1.20354 6.44357 4.32801 1.75924 +16 1 1.98854 1.02727 -0.117121 5.38674 -4.81439 0.472007 +17 2 1.17286 1.52668 -0.137432 -10.3716 4.01885 -0.196355 +18 2 2.69 1.66639 -0.213741 4.03261 1.60042 -0.312306 +ITEM: TIMESTEP +70 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.52005 -0.170765 1.45435 7.42813 -0.682132 -3.31568 +2 2 -0.627795 -0.545781 1.54703 -4.484 0.351316 0.767932 +3 2 -1.9938 -0.405389 2.24937 -1.65789 -0.838399 2.61041 +4 1 -1.72181 -0.363627 -1.31513 2.63115 1.26887 -2.8752 +5 2 -1.86247 -0.45623 -0.365408 -2.65258 -1.1368 1.02525 +6 2 -2.4895 -0.712321 -1.77001 -0.898587 -0.369019 2.21573 +7 1 -0.583063 1.97962 -0.135858 1.67055 0.570004 -0.383383 +8 2 -0.908051 1.51128 0.64094 -1.16679 -0.0785678 -0.520586 +9 2 -0.943124 1.49995 -0.888932 -0.754685 -0.199723 0.596245 +10 1 1.00431 -1.15529 1.43647 -0.676345 0.911353 -2.95012 +11 2 0.95109 -1.53365 0.551095 -1.85378 -3.64627 0.0738184 +12 2 1.52689 -0.36229 1.29214 1.34973 2.90443 2.73267 +13 1 0.96764 -1.3732 -1.34735 0.830518 -7.82237 0.0710001 +14 2 0.049796 -1.13062 -1.50565 0.0671147 3.17314 0.120857 +15 2 1.46341 -0.566541 -1.18509 -0.178936 4.65822 -0.507667 +16 1 1.98438 1.02188 -0.114233 -0.881295 -2.57322 0.275288 +17 2 1.13419 1.48172 -0.149659 1.87909 1.86036 0.463365 +18 2 2.6735 1.67987 -0.202074 -0.651386 1.64881 -0.399918 +ITEM: TIMESTEP +80 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.50978 -0.173017 1.45833 15.0482 -9.57345 5.77126 +2 2 -0.617503 -0.581602 1.56045 -17.3455 8.85736 -2.90765 +3 2 -1.99215 -0.403845 2.25671 0.833211 1.42908 -3.53001 +4 1 -1.71857 -0.360372 -1.31644 -7.32338 -2.11362 6.45601 +5 2 -1.89982 -0.440583 -0.365391 4.39327 0.727605 -4.87947 +6 2 -2.49827 -0.701359 -1.75982 2.51785 1.20426 -1.18541 +7 1 -0.581108 1.97455 -0.140769 -3.87733 -3.80002 1.10694 +8 2 -0.928789 1.51932 0.641149 2.19408 2.20718 -5.07369 +9 2 -0.943839 1.48954 -0.89443 1.32563 2.05291 3.72773 +10 1 0.995847 -1.14613 1.43537 0.755936 -5.6909 -0.46639 +11 2 0.966841 -1.55186 0.550806 1.56938 7.42451 5.54707 +12 2 1.55511 -0.362342 1.35836 -2.79165 -2.9995 -5.36768 +13 1 0.967816 -1.37465 -1.35163 -3.29308 4.65803 -0.872226 +14 2 0.0602027 -1.09254 -1.5264 2.56737 -3.64929 1.27094 +15 2 1.45854 -0.559392 -1.19328 1.84002 -1.84978 0.0538636 +16 1 1.98052 1.0158 -0.111184 -7.14388 11.5516 -0.816233 +17 2 1.12003 1.47724 -0.140032 8.70268 -6.85942 1.26876 +18 2 2.64114 1.706 -0.201685 0.0272078 -3.57662 -0.103793 +ITEM: TIMESTEP +90 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.50003 -0.175917 1.46165 15.3898 -11.884 8.8546 +2 2 -0.608584 -0.600731 1.57129 -23.7815 11.9323 -1.75151 +3 2 -2.00991 -0.394435 2.25305 5.57059 1.55514 -7.64598 +4 1 -1.72137 -0.357368 -1.31563 -1.93902 -0.246344 7.85181 +5 2 -1.87234 -0.43987 -0.353482 -0.118832 -0.772284 -11.4834 +6 2 -2.49861 -0.682857 -1.77755 1.48512 0.513779 4.12935 +7 1 -0.579472 1.97061 -0.145894 -8.85759 -8.26094 2.77276 +8 2 -0.945449 1.52054 0.635243 4.66427 4.57627 -6.94972 +9 2 -0.952686 1.48464 -0.897126 3.60343 4.09955 4.74753 +10 1 0.988258 -1.14419 1.44127 11.1074 1.88534 -20.9154 +11 2 0.971991 -1.50516 0.531218 -4.29535 0.162687 14.3489 +12 2 1.5415 -0.356231 1.32305 -5.76468 -4.25266 5.91571 +13 1 0.969416 -1.37359 -1.35605 -1.23717 3.53556 0.174563 +14 2 0.053578 -1.1004 -1.52114 7.10928 -0.236326 1.96556 +15 2 1.49219 -0.569722 -1.21186 -5.0738 -3.24139 -1.5161 +16 1 1.97824 1.01566 -0.108279 -8.95647 8.69277 0.191958 +17 2 1.10027 1.45664 -0.104435 15.9218 -5.21388 -1.22481 +18 2 2.64464 1.70165 -0.21558 -4.82724 -2.84557 0.534172 +ITEM: TIMESTEP +100 +ITEM: NUMBER OF ATOMS +18 +ITEM: BOX BOUNDS ss ss ss +-2.5173543550999997e+00 2.6752353550999999e+00 +-1.5223951870999999e+00 2.0181841871000001e+00 +-1.7341615612999999e+00 2.2202425613000001e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 -1.4951 -0.17739 1.46185 11.6291 -12.0775 13.5087 +2 2 -0.608426 -0.588808 1.60852 -19.0988 9.4339 -4.86631 +3 2 -2.01619 -0.397996 2.24676 4.77562 3.06476 -9.1756 +4 1 -1.72287 -0.352149 -1.31567 -8.10325 -4.84048 12.8242 +5 2 -1.86729 -0.479262 -0.356777 4.49726 3.58866 -11.0242 +6 2 -2.51926 -0.676876 -1.74282 3.42966 1.20159 -1.20299 +7 1 -0.581355 1.96754 -0.149521 -5.24612 -4.66563 2.71982 +8 2 -0.935394 1.51644 0.636953 2.89489 2.96603 -9.31226 +9 2 -0.942573 1.488 -0.91114 1.96254 2.34604 7.29302 +10 1 0.988651 -1.14425 1.44045 0.840008 -1.36718 -7.83612 +11 2 0.899639 -1.53136 0.543246 5.64911 9.69241 11.7913 +12 2 1.49178 -0.318235 1.33897 -3.7582 -9.86315 -4.79205 +13 1 0.974233 -1.37573 -1.35945 -3.77942 11.331 0.435153 +14 2 0.0583408 -1.08758 -1.49668 6.15796 -3.89994 -0.197074 +15 2 1.48764 -0.558876 -1.24121 -3.14566 -8.24544 0.525665 +16 1 1.97883 1.01496 -0.10404 -9.03485 15.6667 -0.929518 +17 2 1.11471 1.47883 -0.106249 11.9101 -8.77208 -0.858699 +18 2 2.63671 1.70526 -0.232286 -1.57994 -5.55972 1.09694 diff --git a/examples/amoeba/in.ubiquitin.test b/examples/amoeba/in.ubiquitin.test new file mode 100644 index 0000000000..859c53e17f --- /dev/null +++ b/examples/amoeba/in.ubiquitin.test @@ -0,0 +1,56 @@ +# solvated ubiquitin molecule with AMOEBA force field + +units real +boundary p p p +atom_modify sort 0 0.0 + +atom_style amoeba + +bond_style class2 +angle_style amoeba +dihedral_style fourier +improper_style amoeba + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 + +fix pit all amoeba/pitorsion +fix_modify pit energy yes +fix bit all amoeba/bitorsion bitorsion.ubiquitin.data +fix_modify bit energy yes + +# read data file + +read_data data.ubiquitin fix amtype NULL "Tinker Types" & + fix pit "pitorsion types" "PiTorsion Coeffs" & + fix pit pitorsions PiTorsions & + fix bit bitorsions BiTorsions + +pair_style amoeba +pair_coeff * * amoeba_ubiquitin.prm amoeba_ubiquitin.key + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp & + emol etotal press c_virial[*] + +dump 1 all custom 10 dump.ubi id type x y z fx fy fz +dump_modify 1 sort id + +# zero step run + +#run 0 + +# dynamics + +fix 1 all nve + +thermo 1 +run 10 diff --git a/examples/amoeba/in.water_box.amoeba b/examples/amoeba/in.water_box.amoeba index 1ee4fc0018..62abab1a82 100644 --- a/examples/amoeba/in.water_box.amoeba +++ b/examples/amoeba/in.water_box.amoeba @@ -11,9 +11,8 @@ dihedral_style none # per-atom properties required by AMOEBA or HIPPO fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom & - i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes -fix extra2 all property/atom i_polaxe +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d_xaxis d_yaxis d_zaxis # read data file diff --git a/examples/amoeba/in.water_box.amoeba.test b/examples/amoeba/in.water_box.amoeba.test new file mode 100644 index 0000000000..1ee4fc0018 --- /dev/null +++ b/examples/amoeba/in.water_box.amoeba.test @@ -0,0 +1,48 @@ +# water box with AMOEBA or HIPPO + +units real +boundary p p p + +atom_style amoeba +bond_style class2 +angle_style amoeba +dihedral_style none + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom & + i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes +fix extra2 all property/atom i_polaxe + +# read data file + +read_data data.water_box.amoeba fix amtype NULL "Tinker Types" + +# force field + +pair_style amoeba +pair_coeff * * amoeba_water.prm amoeba_water_box.key + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp & + emol etotal press c_virial[*] + +dump 1 all custom 10 dump.water_box id type x y z fx fy fz +dump_modify 1 sort id + +# zero step run + +#run 0 + +# dynamics + +fix 1 all nve + +thermo 10 +run 100 diff --git a/examples/amoeba/in.water_box.hippo b/examples/amoeba/in.water_box.hippo index 2c414017f6..74dc6b6b08 100644 --- a/examples/amoeba/in.water_box.hippo +++ b/examples/amoeba/in.water_box.hippo @@ -11,9 +11,8 @@ dihedral_style none # per-atom properties required by AMOEBA or HIPPO fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom & - i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes -fix extra2 all property/atom i_polaxe +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d_xaxis d_yaxis d_zaxis # read data file diff --git a/examples/amoeba/in.water_box.hippo.test b/examples/amoeba/in.water_box.hippo.test new file mode 100644 index 0000000000..2c414017f6 --- /dev/null +++ b/examples/amoeba/in.water_box.hippo.test @@ -0,0 +1,48 @@ +# water box with AMOEBA or HIPPO + +units real +boundary p p p + +atom_style amoeba +bond_style class2 +angle_style amoeba +dihedral_style none + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom & + i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes +fix extra2 all property/atom i_polaxe + +# read data file + +read_data data.water_box.hippo fix amtype NULL "Tinker Types" + +# force field + +pair_style hippo +pair_coeff * * hippo_water.prm hippo_water_box.key + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp & + emol etotal press c_virial[*] + +dump 1 all custom 10 dump.water_box id type x y z fx fy fz +dump_modify 1 sort id + +# zero step run + +#run 0 + +# dynamics + +fix 1 all nve + +thermo 10 +run 100 diff --git a/examples/amoeba/in.water_dimer.amoeba b/examples/amoeba/in.water_dimer.amoeba index 66fa60e351..cee3683d56 100644 --- a/examples/amoeba/in.water_dimer.amoeba +++ b/examples/amoeba/in.water_dimer.amoeba @@ -11,9 +11,8 @@ dihedral_style none # per-atom properties required by AMOEBA or HIPPO fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom & - i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes -fix extra2 all property/atom i_polaxe +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d_xaxis d_yaxis d_zaxis # read data file diff --git a/examples/amoeba/in.water_dimer.amoeba.test b/examples/amoeba/in.water_dimer.amoeba.test new file mode 100644 index 0000000000..66fa60e351 --- /dev/null +++ b/examples/amoeba/in.water_dimer.amoeba.test @@ -0,0 +1,48 @@ +# water dimer with AMOEBA or HIPPO + +units real +boundary s s s + +atom_style amoeba +bond_style class2 +angle_style amoeba +dihedral_style none + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom & + i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes +fix extra2 all property/atom i_polaxe + +# read data file + +read_data data.water_dimer.amoeba fix amtype NULL "Tinker Types" + +# force field + +pair_style amoeba +pair_coeff * * amoeba_water.prm amoeba_water.key + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp & + emol etotal press c_virial[*] + +dump 1 all custom 10 dump.water_dimer id type x y z fx fy fz +dump_modify 1 sort id + +# zero step run + +#run 0 + +# dynamics + +fix 1 all nve + +thermo 10 +run 100 diff --git a/examples/amoeba/in.water_dimer.hippo b/examples/amoeba/in.water_dimer.hippo index 5ed920ffda..eab29aac9d 100644 --- a/examples/amoeba/in.water_dimer.hippo +++ b/examples/amoeba/in.water_dimer.hippo @@ -11,9 +11,8 @@ dihedral_style none # per-atom properties required by AMOEBA or HIPPO fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom & - i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes -fix extra2 all property/atom i_polaxe +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d_xaxis d_yaxis d_zaxis # read data file diff --git a/examples/amoeba/in.water_dimer.hippo.test b/examples/amoeba/in.water_dimer.hippo.test new file mode 100644 index 0000000000..5ed920ffda --- /dev/null +++ b/examples/amoeba/in.water_dimer.hippo.test @@ -0,0 +1,48 @@ +# water dimer with AMOEBA or HIPPO + +units real +boundary s s s + +atom_style amoeba +bond_style class2 +angle_style amoeba +dihedral_style none + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom & + i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes +fix extra2 all property/atom i_polaxe + +# read data file + +read_data data.water_dimer.hippo fix amtype NULL "Tinker Types" + +# force field + +pair_style hippo +pair_coeff * * hippo_water.prm hippo_water.key + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp & + emol etotal press c_virial[*] + +dump 1 all custom 10 dump.water_dimer id type x y z fx fy fz +dump_modify 1 sort id + +# zero step run + +#run 0 + +# dynamics + +fix 1 all nve + +thermo 10 +run 100 diff --git a/examples/amoeba/in.water_hexamer.amoeba b/examples/amoeba/in.water_hexamer.amoeba index bc14833778..e04da7cd88 100644 --- a/examples/amoeba/in.water_hexamer.amoeba +++ b/examples/amoeba/in.water_hexamer.amoeba @@ -11,9 +11,8 @@ dihedral_style none # per-atom properties required by AMOEBA or HIPPO fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom & - i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes -fix extra2 all property/atom i_polaxe +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d_xaxis d_yaxis d_zaxis # read data file diff --git a/examples/amoeba/in.water_hexamer.amoeba.test b/examples/amoeba/in.water_hexamer.amoeba.test new file mode 100644 index 0000000000..bc14833778 --- /dev/null +++ b/examples/amoeba/in.water_hexamer.amoeba.test @@ -0,0 +1,48 @@ +# water hexamer with AMOEBA or HIPPO + +units real +boundary s s s + +atom_style amoeba +bond_style class2 +angle_style amoeba +dihedral_style none + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom & + i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes +fix extra2 all property/atom i_polaxe + +# read data file + +read_data data.water_hexamer.amoeba fix amtype NULL "Tinker Types" + +# force field + +pair_style amoeba +pair_coeff * * amoeba_water.prm amoeba_water.key + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp & + emol etotal press c_virial[*] + +dump 1 all custom 10 dump.water_hexamer id type x y z fx fy fz +dump_modify 1 sort id + +# zero step run + +#run 0 + +# dynamics + +fix 1 all nve + +thermo 10 +run 100 diff --git a/examples/amoeba/in.water_hexamer.hippo b/examples/amoeba/in.water_hexamer.hippo index 28a06dcefe..3529b1b09c 100644 --- a/examples/amoeba/in.water_hexamer.hippo +++ b/examples/amoeba/in.water_hexamer.hippo @@ -11,9 +11,8 @@ dihedral_style none # per-atom properties required by AMOEBA or HIPPO fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom & - i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes -fix extra2 all property/atom i_polaxe +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d_xaxis d_yaxis d_zaxis # read data file diff --git a/examples/amoeba/in.water_hexamer.hippo.test b/examples/amoeba/in.water_hexamer.hippo.test new file mode 100644 index 0000000000..28a06dcefe --- /dev/null +++ b/examples/amoeba/in.water_hexamer.hippo.test @@ -0,0 +1,48 @@ +# water hexamer with AMOEBA or HIPPO + +units real +boundary s s s + +atom_style amoeba +bond_style class2 +angle_style amoeba +dihedral_style none + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom & + i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes +fix extra2 all property/atom i_polaxe + +# read data file + +read_data data.water_hexamer.hippo fix amtype NULL "Tinker Types" + +# force field + +pair_style hippo +pair_coeff * * hippo_water.prm hippo_water.key + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp & + emol etotal press c_virial[*] + +dump 1 all custom 10 dump.water_hexamer id type x y z fx fy fz +dump_modify 1 sort id + +# zero step run + +#run 0 + +# dynamics + +fix 1 all nve + +thermo 10 +run 100 diff --git a/examples/amoeba/log.ubi.1.test b/examples/amoeba/log.ubi.1.test new file mode 100644 index 0000000000..f931a6aeb3 --- /dev/null +++ b/examples/amoeba/log.ubi.1.test @@ -0,0 +1,162 @@ +LAMMPS (24 Mar 2022) +# solvated ubiquitin molecule with AMOEBA force field + +units real +boundary p p p +atom_modify sort 0 0.0 + +atom_style amoeba + +bond_style class2 +angle_style amoeba +dihedral_style fourier +improper_style amoeba + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix pit all amoeba/pitorsion +fix_modify pit energy yes +fix bit all amoeba/bitorsion bitorsion.ubiquitin.data +fix_modify bit energy yes + +fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes +fix extra2 all property/atom i_polaxe + +#read_data data.ubiquitin fix amtype NULL "Tinker Types" +read_data data.ubiquitin fix amtype NULL "Tinker Types" fix pit "pitorsion types" "PiTorsion Coeffs" fix pit pitorsions PiTorsions fix bit bitorsions BiTorsions +Reading data file ... + orthogonal box = (0 0 0) to (54.99 41.91 41.91) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 9737 atoms + scanning bonds ... + 4 = max bonds/atom + scanning angles ... + 6 = max angles/atom + scanning dihedrals ... + 18 = max dihedrals/atom + scanning impropers ... + 3 = max impropers/atom + reading bonds ... + 6908 bonds + reading angles ... + 5094 angles + reading dihedrals ... + 3297 dihedrals + reading impropers ... + 651 impropers +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 4 = max # of 1-2 neighbors + 9 = max # of 1-3 neighbors + 19 = max # of 1-4 neighbors + 21 = max # of special neighbors + special bonds CPU = 0.004 seconds + read_data CPU = 0.076 seconds + +pair_style amoeba +pair_coeff * * amoeba_ubiquitin.prm amoeba_ubiquitin.key + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0.5 0.5 0.5 + special bond factors coul: 0.5 0.5 0.5 + 4 = max # of 1-2 neighbors + 9 = max # of 1-3 neighbors + 19 = max # of 1-4 neighbors + 58 = max # of 1-5 neighbors + 21 = max # of special neighbors + special bonds CPU = 0.006 seconds + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] + +dump 1 all custom 10 dump.ubi id type x y z fx fy fz +dump_modify 1 sort id + +# zero step run + +#run 0 + +# dynamics + +fix 1 all nve + +thermo 1 +run 10 +AMOEBA/HIPPO force field settings + hal: cut 12 taper 10.8 vscale 0 0 1 1 + multipole: cut 7 aewald 0.4 bsorder 5 FFT 60 48 48 mscale 0 0 0.4 1 + polar: cut 7 aewald 0.5 bsorder 5 FFT 60 48 48 + pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 1 1 1 1 d/u scale 0 1 + precondition: cut 4.5 + generated 0 of 15 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 14 + ghost atom cutoff = 14 + binsize = 7, bins = 8 6 6 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair amoeba, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d + bin: standard + AMOEBA/HIPPO group count: 3196 +Per MPI rank memory allocation (min/avg/max) = 98.55 | 98.55 | 98.55 Mbytes + Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] + 0 0 -35338.057 2856.5938 1955.5431 224.37609 65.00809 5101.5211 -30247.585 -6336.5196 -5795.4272 -6329.8149 -6884.3167 349.52657 77.164877 652.41925 + 1 29.61379 -35356.153 2037.3541 1840.7883 223.90217 64.293945 4166.3385 -30341.522 -6486.773 -6452.8463 -6841.5982 -7386.1106 311.38025 120.72605 545.35513 + 2 78.518242 -35383.65 825.39919 1538.3909 222.55095 62.191009 2648.5321 -30467.814 -5502.9841 -6410.2998 -6396.1829 -6937.8137 217.3515 210.76948 294.28051 + 3 88.8921 -35402.11 938.99299 1162.2914 220.5271 58.832521 2380.644 -30453.516 -1929.5417 -3331.1291 -2769.7218 -3350.5733 117.32302 279.72705 31.237776 + 4 68.740402 -35477.589 2048.0659 858.03795 218.14277 54.460022 3178.7066 -30316.325 2041.1138 594.25938 1665.7799 1030.8539 66.230421 304.28296 -155.80224 + 5 76.267862 -35707.869 2206.6534 736.37385 215.75693 49.401674 3208.1859 -30299.377 2276.9276 536.21124 1893.4621 1258.492 92.097191 299.65604 -228.58369 + 6 118.24373 -36092.77 1166.179 815.59206 213.67399 44.022297 2239.4673 -30435.629 -1677.8051 -3988.2428 -2669.6848 -3247.7207 197.42472 285.87129 -162.35459 + 7 137.7204 -36521.444 782.87113 1026.745 212.04289 38.686259 2060.3452 -30479.082 -5987.83 -8386.8104 -7363.188 -7888.261 357.00835 253.66346 32.827786 + 8 112.66452 -36897.181 1750.0569 1269.152 210.83571 33.742799 3263.7874 -30379.432 -7886.4081 -9703.2601 -9043.015 -9555.2908 490.76046 182.31259 278.727 + 9 88.237359 -37209.906 2695.1766 1454.55 209.91331 29.503458 4389.1434 -30276.565 -8202.16 -9492.368 -9110.7037 -9639.2288 502.55699 107.82333 443.6705 + +AMEOBA/HIPPO timing info: + Init time: 0.0295323 0.00130007 + Hal time: 7.40889 32.6154 + Mpole time: 2.19209 9.65001 + Induce time: 8.54492 37.6164 + Polar time: 4.5405 19.9882 + Total time: 22.7159 + + 10 108.86756 -37474.988 2240.4603 1523.7936 209.10313 26.208515 3999.5656 -30333.279 -8468.4347 -9956.923 -9709.5874 -10224.682 365.98214 95.262991 425.12746 +Loop time of 22.7636 on 1 procs for 10 steps with 9737 atoms + +Performance: 0.038 ns/day, 632.324 hours/ns, 0.439 timesteps/s +98.1% CPU use with 1 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 22.716 | 22.716 | 22.716 | 0.0 | 99.79 +Bond | 0.015795 | 0.015795 | 0.015795 | 0.0 | 0.07 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.003791 | 0.003791 | 0.003791 | 0.0 | 0.02 +Output | 0.024013 | 0.024013 | 0.024013 | 0.0 | 0.11 +Modify | 0.00335 | 0.00335 | 0.00335 | 0.0 | 0.01 +Other | | 0.0006405 | | | 0.00 + +Nlocal: 9737 ave 9737 max 9737 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 31511 ave 31511 max 31511 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 5.6393e+06 ave 5.6393e+06 max 5.6393e+06 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 5639296 +Ave neighs/atom = 579.16155 +Ave special neighs/atom = 3.1364897 +Neighbor list builds = 0 +Dangerous builds = 0 +Total wall time: 0:00:26 diff --git a/examples/amoeba/log.ubi.32.test b/examples/amoeba/log.ubi.32.test new file mode 100644 index 0000000000..bdb97fe194 --- /dev/null +++ b/examples/amoeba/log.ubi.32.test @@ -0,0 +1,162 @@ +LAMMPS (24 Mar 2022) +# solvated ubiquitin molecule with AMOEBA force field + +units real +boundary p p p +atom_modify sort 0 0.0 + +atom_style amoeba + +bond_style class2 +angle_style amoeba +dihedral_style fourier +improper_style amoeba + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix pit all amoeba/pitorsion +fix_modify pit energy yes +fix bit all amoeba/bitorsion bitorsion.ubiquitin.data +fix_modify bit energy yes + +fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes +fix extra2 all property/atom i_polaxe + +#read_data data.ubiquitin fix amtype NULL "Tinker Types" +read_data data.ubiquitin fix amtype NULL "Tinker Types" fix pit "pitorsion types" "PiTorsion Coeffs" fix pit pitorsions PiTorsions fix bit bitorsions BiTorsions +Reading data file ... + orthogonal box = (0 0 0) to (54.99 41.91 41.91) + 4 by 2 by 4 MPI processor grid + reading atoms ... + 9737 atoms + scanning bonds ... + 4 = max bonds/atom + scanning angles ... + 6 = max angles/atom + scanning dihedrals ... + 18 = max dihedrals/atom + scanning impropers ... + 3 = max impropers/atom + reading bonds ... + 6908 bonds + reading angles ... + 5094 angles + reading dihedrals ... + 3297 dihedrals + reading impropers ... + 651 impropers +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 4 = max # of 1-2 neighbors + 9 = max # of 1-3 neighbors + 19 = max # of 1-4 neighbors + 21 = max # of special neighbors + special bonds CPU = 0.002 seconds + read_data CPU = 0.120 seconds + +pair_style amoeba +pair_coeff * * amoeba_ubiquitin.prm amoeba_ubiquitin.key + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0.5 0.5 0.5 + special bond factors coul: 0.5 0.5 0.5 + 4 = max # of 1-2 neighbors + 9 = max # of 1-3 neighbors + 19 = max # of 1-4 neighbors + 58 = max # of 1-5 neighbors + 21 = max # of special neighbors + special bonds CPU = 0.002 seconds + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] + +dump 1 all custom 10 dump.ubi id type x y z fx fy fz +dump_modify 1 sort id + +# zero step run + +#run 0 + +# dynamics + +fix 1 all nve + +thermo 1 +run 10 +AMOEBA/HIPPO force field settings + hal: cut 12 taper 10.8 vscale 0 0 1 1 + multipole: cut 7 aewald 0.4 bsorder 5 FFT 60 48 48 mscale 0 0 0.4 1 + polar: cut 7 aewald 0.5 bsorder 5 FFT 60 48 48 + pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 1 1 1 1 d/u scale 0 1 + precondition: cut 4.5 + generated 0 of 15 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 14 + ghost atom cutoff = 14 + binsize = 7, bins = 8 6 6 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair amoeba, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d + bin: standard + AMOEBA/HIPPO group count: 3196 +Per MPI rank memory allocation (min/avg/max) = 26.19 | 26.49 | 27.59 Mbytes + Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] + 0 0 -35338.057 2856.5938 1955.5431 224.37609 65.00809 5101.5211 -30247.585 -6336.5196 -5795.4272 -6329.8149 -6884.3167 349.52657 77.164877 652.41925 + 1 29.61379 -35356.153 2037.3541 1840.7883 223.90217 64.293945 4166.3385 -30341.522 -6486.773 -6452.8463 -6841.5982 -7386.1106 311.38025 120.72605 545.35513 + 2 78.518242 -35383.65 825.39919 1538.3909 222.55095 62.191009 2648.5321 -30467.814 -5502.9841 -6410.2998 -6396.1829 -6937.8137 217.3515 210.76948 294.28051 + 3 88.8921 -35402.11 938.99299 1162.2914 220.5271 58.832521 2380.644 -30453.516 -1929.5417 -3331.1291 -2769.7218 -3350.5733 117.32302 279.72705 31.237776 + 4 68.740402 -35477.589 2048.0659 858.03795 218.14277 54.460022 3178.7066 -30316.325 2041.1138 594.25938 1665.7799 1030.8539 66.230421 304.28296 -155.80224 + 5 76.267862 -35707.869 2206.6534 736.37385 215.75693 49.401674 3208.1859 -30299.377 2276.9276 536.21124 1893.4621 1258.492 92.097191 299.65604 -228.58369 + 6 118.24373 -36092.77 1166.179 815.59206 213.67399 44.022297 2239.4673 -30435.629 -1677.8051 -3988.2428 -2669.6848 -3247.7207 197.42472 285.87129 -162.35459 + 7 137.7204 -36521.444 782.87113 1026.745 212.04289 38.686259 2060.3452 -30479.082 -5987.83 -8386.8104 -7363.188 -7888.261 357.00835 253.66346 32.827786 + 8 112.66452 -36897.181 1750.0569 1269.152 210.83571 33.742799 3263.7874 -30379.432 -7886.4081 -9703.2601 -9043.015 -9555.2908 490.76046 182.31259 278.727 + 9 88.237359 -37209.906 2695.1766 1454.55 209.91331 29.503458 4389.1434 -30276.565 -8202.16 -9492.368 -9110.7037 -9639.2288 502.55699 107.82333 443.6705 + +AMEOBA/HIPPO timing info: + Init time: 0.0255174 0.0162332 + Hal time: 0.273968 17.4289 + Mpole time: 0.202832 12.9035 + Induce time: 0.79876 50.8142 + Polar time: 0.270839 17.2298 + Total time: 1.57192 + + 10 108.86756 -37474.988 2240.4603 1523.7936 209.10313 26.208515 3999.5656 -30333.279 -8468.4347 -9956.923 -9709.5874 -10224.682 365.98214 95.262991 425.12746 +Loop time of 1.58782 on 32 procs for 10 steps with 9737 atoms + +Performance: 0.544 ns/day, 44.106 hours/ns, 6.298 timesteps/s +99.3% CPU use with 32 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 1.5717 | 1.5724 | 1.5732 | 0.0 | 99.03 +Bond | 0.00025512 | 0.00072817 | 0.0025027 | 0.0 | 0.05 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.008108 | 0.010596 | 0.011659 | 0.9 | 0.67 +Output | 0.0032598 | 0.0035294 | 0.0038605 | 0.2 | 0.22 +Modify | 0.00017743 | 0.00030162 | 0.00054742 | 0.0 | 0.02 +Other | | 0.0002902 | | | 0.02 + +Nlocal: 304.281 ave 326 max 273 min +Histogram: 1 1 0 5 2 8 3 6 4 2 +Nghost: 7618.59 ave 7678 max 7545 min +Histogram: 1 1 4 4 5 5 2 2 4 4 +Neighs: 176228 ave 204476 max 149390 min +Histogram: 3 3 3 2 6 2 5 4 2 2 + +Total # of neighbors = 5639296 +Ave neighs/atom = 579.16155 +Ave special neighs/atom = 3.1364897 +Neighbor list builds = 0 +Dangerous builds = 0 +Total wall time: 0:00:02 diff --git a/examples/amoeba/log.water_box.amoeba.1.test b/examples/amoeba/log.water_box.amoeba.1.test new file mode 100644 index 0000000000..dfdf8d27aa --- /dev/null +++ b/examples/amoeba/log.water_box.amoeba.1.test @@ -0,0 +1,149 @@ +LAMMPS (24 Mar 2022) +# water box with AMOEBA or HIPPO + +units real +boundary p p p + +atom_style amoeba +bond_style class2 +angle_style amoeba +dihedral_style none + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes +fix extra2 all property/atom i_polaxe + +# read data file + +read_data data.water_box.amoeba fix amtype NULL "Tinker Types" +Reading data file ... + orthogonal box = (0 0 0) to (18.643 18.643 18.643) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 648 atoms + scanning bonds ... + 2 = max bonds/atom + scanning angles ... + 1 = max angles/atom + reading bonds ... + 432 bonds + reading angles ... + 216 angles +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + read_data CPU = 0.010 seconds + +# force field + +pair_style amoeba +pair_coeff * * amoeba_water.prm amoeba_water_box.key + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0.5 0.5 0.5 + special bond factors coul: 0.5 0.5 0.5 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of 1-5 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.001 seconds + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] + +dump 1 all custom 10 dump.water_box id type x y z fx fy fz +dump_modify 1 sort id + +# zero step run + +#run 0 + +# dynamics + +fix 1 all nve + +thermo 10 +run 100 +AMOEBA/HIPPO force field settings + hal: cut 7 taper 6 vscale 0 0 1 1 + multipole: cut 7 aewald 0.4 bsorder 5 FFT 50 50 50 mscale 0 0 0.4 1 + polar: cut 7 aewald 0.5 bsorder 5 FFT 50 50 50 + pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 1 1 1 1 d/u scale 0 1 + precondition: cut 4.5 + generated 0 of 1 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 9 + ghost atom cutoff = 9 + binsize = 4.5, bins = 5 5 5 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair amoeba, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d + bin: standard + AMOEBA/HIPPO group count: 216 +Per MPI rank memory allocation (min/avg/max) = 10.9 | 10.9 | 10.9 Mbytes + Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] + 0 0 -2172.0441 166.82637 83.732524 0 0 250.5589 -1921.4852 -6181.7112 -4771.8292 -6955.3278 -6817.9765 -272.19746 3173.3487 2229.6526 + 10 105.50439 -2373.6865 136.67908 106.86552 0 0 243.54459 -1926.6678 -8441.2174 -10450.318 -9514.124 -9665.625 -301.45304 322.2435 1916.9694 + 20 143.90097 -2358.3516 70.951764 76.777106 0 0 147.72887 -1933.0976 -7370.463 -7728.4884 -11580.562 -8676.0017 -807.21546 780.4123 2096.7667 + 30 157.22768 -2375.4639 50.396281 87.108719 0 0 137.505 -1934.7321 -4449.9504 -6946.5881 -7865.3435 -4955.5443 -417.85139 -1004.0926 -36.630383 + 40 150.92709 -2354.1768 78.484257 53.799494 0 0 132.28375 -1930.8175 353.40845 -939.7978 -4636.1858 475.75837 -1074.4762 -1584.304 -574.27211 + 50 153.02614 -2388.7287 100.20124 65.814409 0 0 166.01565 -1927.5893 3975.1595 1366.008 426.2343 3887.1078 -1807.1658 -2534.8393 -2118.6912 + 60 155.01798 -2364.31 92.948309 44.252938 0 0 137.20125 -1928.1435 5793.7978 3521.2541 1421.9416 6110.7678 -1536.937 -2559.5674 -1502.2038 + 70 166.70629 -2383.4827 76.492455 55.020922 0 0 131.51338 -1930.4622 4743.9587 1916.6786 2839.9241 2670.7568 -169.67855 -187.58379 -2256.4529 + 80 171.82933 -2388.0347 76.463333 49.138785 0 0 125.60212 -1931.0453 2210.1222 -319.99043 330.98785 -394.25628 -44.858027 252.35533 -1985.0908 + 90 175.7327 -2423.7974 90.784969 63.725029 0 0 154.51 -1930.3722 -917.58179 -3941.9566 -2568.4278 -3415.3121 196.38051 2366.2885 -263.52434 + +AMEOBA/HIPPO timing info: + Init time: 0.0268067 0.000648832 + Hal time: 0.950781 2.30127 + Mpole time: 2.62623 6.35653 + Induce time: 31.3736 75.9368 + Polar time: 6.33798 15.3405 + Total time: 41.3154 + + 100 173.73319 -2422.3616 99.761403 57.29505 0 0 157.05645 -1930.2461 -3586.4169 -5733.9943 -5881.4025 -6235.1905 -230.75166 959.02899 406.2349 +Loop time of 41.3458 on 1 procs for 100 steps with 648 atoms + +Performance: 0.209 ns/day, 114.849 hours/ns, 2.419 timesteps/s +99.6% CPU use with 1 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 41.316 | 41.316 | 41.316 | 0.0 | 99.93 +Bond | 0.0034989 | 0.0034989 | 0.0034989 | 0.0 | 0.01 +Neigh | 0.0060545 | 0.0060545 | 0.0060545 | 0.0 | 0.01 +Comm | 0.0037812 | 0.0037812 | 0.0037812 | 0.0 | 0.01 +Output | 0.014701 | 0.014701 | 0.014701 | 0.0 | 0.04 +Modify | 0.00098692 | 0.00098692 | 0.00098692 | 0.0 | 0.00 +Other | | 0.001033 | | | 0.00 + +Nlocal: 648 ave 648 max 648 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 4290 ave 4290 max 4290 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 98543 ave 98543 max 98543 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 98543 +Ave neighs/atom = 152.07253 +Ave special neighs/atom = 2 +Neighbor list builds = 2 +Dangerous builds = 0 +Total wall time: 0:00:42 diff --git a/examples/amoeba/log.water_box.amoeba.32.test b/examples/amoeba/log.water_box.amoeba.32.test new file mode 100644 index 0000000000..6f74cf5d2d --- /dev/null +++ b/examples/amoeba/log.water_box.amoeba.32.test @@ -0,0 +1,149 @@ +LAMMPS (24 Mar 2022) +# water box with AMOEBA or HIPPO + +units real +boundary p p p + +atom_style amoeba +bond_style class2 +angle_style amoeba +dihedral_style none + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes +fix extra2 all property/atom i_polaxe + +# read data file + +read_data data.water_box.amoeba fix amtype NULL "Tinker Types" +Reading data file ... + orthogonal box = (0 0 0) to (18.643 18.643 18.643) + 2 by 4 by 4 MPI processor grid + reading atoms ... + 648 atoms + scanning bonds ... + 2 = max bonds/atom + scanning angles ... + 1 = max angles/atom + reading bonds ... + 432 bonds + reading angles ... + 216 angles +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.002 seconds + read_data CPU = 0.026 seconds + +# force field + +pair_style amoeba +pair_coeff * * amoeba_water.prm amoeba_water_box.key + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0.5 0.5 0.5 + special bond factors coul: 0.5 0.5 0.5 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of 1-5 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.002 seconds + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] + +dump 1 all custom 10 dump.water_box id type x y z fx fy fz +dump_modify 1 sort id + +# zero step run + +#run 0 + +# dynamics + +fix 1 all nve + +thermo 10 +run 100 +AMOEBA/HIPPO force field settings + hal: cut 7 taper 6 vscale 0 0 1 1 + multipole: cut 7 aewald 0.4 bsorder 5 FFT 50 50 50 mscale 0 0 0.4 1 + polar: cut 7 aewald 0.5 bsorder 5 FFT 50 50 50 + pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 1 1 1 1 d/u scale 0 1 + precondition: cut 4.5 + generated 0 of 1 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 9 + ghost atom cutoff = 9 + binsize = 4.5, bins = 5 5 5 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair amoeba, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d + bin: standard + AMOEBA/HIPPO group count: 216 +Per MPI rank memory allocation (min/avg/max) = 10.07 | 10.08 | 10.34 Mbytes + Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] + 0 0 -2172.0441 166.82637 83.732524 0 0 250.5589 -1921.4852 -6181.7112 -4771.8292 -6955.3278 -6817.9765 -272.19746 3173.3487 2229.6526 + 10 105.50439 -2373.6865 136.67908 106.86552 0 0 243.54459 -1926.6678 -8441.2174 -10450.318 -9514.124 -9665.625 -301.45304 322.2435 1916.9694 + 20 143.90097 -2358.3516 70.951764 76.777106 0 0 147.72887 -1933.0976 -7370.463 -7728.4884 -11580.562 -8676.0017 -807.21546 780.4123 2096.7667 + 30 157.22768 -2375.4639 50.396281 87.108719 0 0 137.505 -1934.7321 -4449.9504 -6946.5881 -7865.3435 -4955.5443 -417.85139 -1004.0926 -36.630383 + 40 150.92709 -2354.1768 78.484257 53.799494 0 0 132.28375 -1930.8175 353.40845 -939.7978 -4636.1858 475.75837 -1074.4762 -1584.304 -574.27211 + 50 153.02614 -2388.7287 100.20124 65.814409 0 0 166.01565 -1927.5893 3975.1595 1366.008 426.2343 3887.1078 -1807.1658 -2534.8393 -2118.6912 + 60 155.01798 -2364.31 92.948309 44.252938 0 0 137.20125 -1928.1435 5793.7978 3521.2541 1421.9416 6110.7678 -1536.937 -2559.5674 -1502.2038 + 70 166.70629 -2383.4827 76.492455 55.020922 0 0 131.51338 -1930.4622 4743.9587 1916.6786 2839.9241 2670.7568 -169.67855 -187.58379 -2256.4529 + 80 171.82933 -2388.0347 76.463333 49.138785 0 0 125.60212 -1931.0453 2210.1222 -319.99043 330.98785 -394.25628 -44.858027 252.35533 -1985.0908 + 90 175.7327 -2423.7974 90.784969 63.725029 0 0 154.51 -1930.3722 -917.58179 -3941.9566 -2568.4278 -3415.3121 196.38051 2366.2885 -263.52434 + +AMEOBA/HIPPO timing info: + Init time: 0.0370802 0.00577897 + Hal time: 0.0365961 0.570352 + Mpole time: 0.548509 8.54854 + Induce time: 4.8345 75.346 + Polar time: 0.95968 14.9567 + Total time: 6.4164 + + 100 173.73319 -2422.3616 99.761403 57.29505 0 0 157.05645 -1930.2461 -3586.4169 -5733.9943 -5881.4025 -6235.1905 -230.75166 959.02899 406.2349 +Loop time of 6.44751 on 32 procs for 100 steps with 648 atoms + +Performance: 1.340 ns/day, 17.910 hours/ns, 15.510 timesteps/s +99.8% CPU use with 32 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 6.4102 | 6.4179 | 6.4248 | 0.2 | 99.54 +Bond | 0.00029057 | 0.00042623 | 0.00057421 | 0.0 | 0.01 +Neigh | 0.00040172 | 0.00045575 | 0.00052495 | 0.0 | 0.01 +Comm | 0.016267 | 0.023118 | 0.030703 | 2.6 | 0.36 +Output | 0.0037201 | 0.003804 | 0.0040605 | 0.1 | 0.06 +Modify | 0.00028994 | 0.00038094 | 0.0005128 | 0.0 | 0.01 +Other | | 0.001461 | | | 0.02 + +Nlocal: 20.25 ave 26 max 12 min +Histogram: 1 1 3 1 2 7 3 11 1 2 +Nghost: 1381.97 ave 1413 max 1354 min +Histogram: 3 5 4 0 6 3 1 4 5 1 +Neighs: 3079.47 ave 4080 max 1858 min +Histogram: 1 3 1 2 5 6 7 5 0 2 + +Total # of neighbors = 98543 +Ave neighs/atom = 152.07253 +Ave special neighs/atom = 2 +Neighbor list builds = 2 +Dangerous builds = 0 +Total wall time: 0:00:06 diff --git a/examples/amoeba/log.water_box.hippo.1.test b/examples/amoeba/log.water_box.hippo.1.test new file mode 100644 index 0000000000..d519e1ba86 --- /dev/null +++ b/examples/amoeba/log.water_box.hippo.1.test @@ -0,0 +1,153 @@ +LAMMPS (24 Mar 2022) +# water box with AMOEBA or HIPPO + +units real +boundary p p p + +atom_style amoeba +bond_style class2 +angle_style amoeba +dihedral_style none + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes +fix extra2 all property/atom i_polaxe + +# read data file + +read_data data.water_box.hippo fix amtype NULL "Tinker Types" +Reading data file ... + orthogonal box = (0 0 0) to (18.643 18.643 18.643) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 648 atoms + scanning bonds ... + 2 = max bonds/atom + scanning angles ... + 1 = max angles/atom + reading bonds ... + 432 bonds + reading angles ... + 216 angles +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + read_data CPU = 0.007 seconds + +# force field + +pair_style hippo +pair_coeff * * hippo_water.prm hippo_water_box.key + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0.5 0.5 0.5 + special bond factors coul: 0.5 0.5 0.5 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of 1-5 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] + +dump 1 all custom 10 dump.water_box id type x y z fx fy fz +dump_modify 1 sort id + +# zero step run + +#run 0 + +# dynamics + +fix 1 all nve + +thermo 10 +run 100 +AMOEBA/HIPPO force field settings + repulsion: cut 7 taper 6 rscale 0 0 1 1 + qxfer: cut 7 taper 6 mscale 0 0 0.4 1 + dispersion: cut 7 aewald 0.45 bsorder 4 FFT 16 16 16 dspscale 0 0 0.4 1 + multipole: cut 7 aewald 0.4 bsorder 5 FFT 24 24 24 mscale 0 0 0.4 1 + polar: cut 7 aewald 0.5 bsorder 5 FFT 24 24 24 + pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 0.2 1 1 1 d/u scale 0 1 + precondition: cut 4.5 + generated 0 of 1 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 9 + ghost atom cutoff = 9 + binsize = 4.5, bins = 5 5 5 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair hippo, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d + bin: standard + AMOEBA/HIPPO group count: 216 +Per MPI rank memory allocation (min/avg/max) = 10.89 | 10.89 | 10.89 Mbytes + Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] + 0 0 -2188.594 166.82637 77.478353 0 0 244.30473 -1944.2893 -10859.589 -9285.4645 -11598.049 -11695.254 -282.7072 3164.4148 2495.2578 + 10 100.94691 -2350.192 116.13156 88.56605 0 0 204.69761 -1950.8098 -11480.919 -13574.139 -12190.797 -12798.212 -263.77028 280.62864 1974.1486 + 20 153.91622 -2358.3058 36.396961 66.22466 0 0 102.62162 -1958.8438 -7778.4529 -8492.3868 -11999.431 -9125.9998 -917.99962 589.09064 1788.2094 + 30 145.5951 -2343.9956 39.651541 65.833248 0 0 105.48479 -1957.7184 -288.79965 -2574.4466 -3820.4824 -414.28285 -347.51491 -1147.3995 -126.71025 + 40 126.87801 -2340.2623 102.93951 43.896946 0 0 146.83646 -1948.7309 6766.15 5908.7048 1280.0961 7930.8191 -1085.6811 -1596.6859 -714.82888 + 50 134.52078 -2358.9232 107.49288 44.253826 0 0 151.74671 -1947.7419 8762.4348 6023.4661 5377.0189 9396.0316 -1629.1364 -1663.1666 -2381.51 + 60 173.10181 -2374.3854 51.097314 33.03646 0 0 84.133774 -1956.4102 4614.2907 1719.1989 505.79149 4552.3167 -1661.1714 -587.92108 -1380.6732 + 70 184.86849 -2391.6106 39.916931 35.978152 0 0 75.895083 -1959.1811 -2146.9339 -4993.4021 -4095.6729 -4897.5768 -833.09046 1542.411 -1539.5266 + 80 164.75795 -2406.3017 101.94229 33.067832 0 0 135.01013 -1953.542 -8779.3265 -10545.409 -10418.702 -12098.858 -1319.194 1750.3511 -275.1272 + 90 151.17491 -2434.6876 152.21826 41.301673 0 0 193.51993 -1949.6141 -13330.691 -15436.505 -13791.461 -16934.674 149.25497 2289.1026 976.14333 + +AMEOBA/HIPPO timing info: + Init time: 0.0135815 0.00137415 + Repls time: 1.1283 11.4159 + Disp time: 0.913907 9.24672 + Mpole time: 1.76939 17.9023 + Induce time: 3.50511 35.4639 + Polar time: 2.23426 22.6058 + Qxfer time: 0.319009 3.22767 + Total time: 9.88358 + + 100 166.99163 -2452.5298 143.57768 35.341459 0 0 178.91914 -1951.5533 -14918.51 -16077.49 -17353.738 -18140.466 19.009088 1487.0469 1084.0231 +Loop time of 9.91124 on 1 procs for 100 steps with 648 atoms + +Performance: 0.872 ns/day, 27.531 hours/ns, 10.090 timesteps/s +98.6% CPU use with 1 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 9.8837 | 9.8837 | 9.8837 | 0.0 | 99.72 +Bond | 0.0026063 | 0.0026063 | 0.0026063 | 0.0 | 0.03 +Neigh | 0.0058854 | 0.0058854 | 0.0058854 | 0.0 | 0.06 +Comm | 0.002753 | 0.002753 | 0.002753 | 0.0 | 0.03 +Output | 0.014779 | 0.014779 | 0.014779 | 0.0 | 0.15 +Modify | 0.00071385 | 0.00071385 | 0.00071385 | 0.0 | 0.01 +Other | | 0.0007555 | | | 0.01 + +Nlocal: 648 ave 648 max 648 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 4282 ave 4282 max 4282 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 98490 ave 98490 max 98490 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 98490 +Ave neighs/atom = 151.99074 +Ave special neighs/atom = 2 +Neighbor list builds = 2 +Dangerous builds = 0 +Total wall time: 0:00:10 diff --git a/examples/amoeba/log.water_box.hippo.32.test b/examples/amoeba/log.water_box.hippo.32.test new file mode 100644 index 0000000000..d5208570c4 --- /dev/null +++ b/examples/amoeba/log.water_box.hippo.32.test @@ -0,0 +1,153 @@ +LAMMPS (24 Mar 2022) +# water box with AMOEBA or HIPPO + +units real +boundary p p p + +atom_style amoeba +bond_style class2 +angle_style amoeba +dihedral_style none + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes +fix extra2 all property/atom i_polaxe + +# read data file + +read_data data.water_box.hippo fix amtype NULL "Tinker Types" +Reading data file ... + orthogonal box = (0 0 0) to (18.643 18.643 18.643) + 2 by 4 by 4 MPI processor grid + reading atoms ... + 648 atoms + scanning bonds ... + 2 = max bonds/atom + scanning angles ... + 1 = max angles/atom + reading bonds ... + 432 bonds + reading angles ... + 216 angles +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.002 seconds + read_data CPU = 0.026 seconds + +# force field + +pair_style hippo +pair_coeff * * hippo_water.prm hippo_water_box.key + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0.5 0.5 0.5 + special bond factors coul: 0.5 0.5 0.5 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of 1-5 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.002 seconds + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] + +dump 1 all custom 10 dump.water_box id type x y z fx fy fz +dump_modify 1 sort id + +# zero step run + +#run 0 + +# dynamics + +fix 1 all nve + +thermo 10 +run 100 +AMOEBA/HIPPO force field settings + repulsion: cut 7 taper 6 rscale 0 0 1 1 + qxfer: cut 7 taper 6 mscale 0 0 0.4 1 + dispersion: cut 7 aewald 0.45 bsorder 4 FFT 16 16 16 dspscale 0 0 0.4 1 + multipole: cut 7 aewald 0.4 bsorder 5 FFT 24 24 24 mscale 0 0 0.4 1 + polar: cut 7 aewald 0.5 bsorder 5 FFT 24 24 24 + pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 0.2 1 1 1 d/u scale 0 1 + precondition: cut 4.5 + generated 0 of 1 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 9 + ghost atom cutoff = 9 + binsize = 4.5, bins = 5 5 5 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair hippo, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d + bin: standard + AMOEBA/HIPPO group count: 216 +Per MPI rank memory allocation (min/avg/max) = 10.07 | 10.08 | 10.34 Mbytes + Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] + 0 0 -2188.594 166.82637 77.478353 0 0 244.30473 -1944.2893 -10859.589 -9285.4645 -11598.049 -11695.254 -282.7072 3164.4148 2495.2578 + 10 100.94691 -2350.192 116.13156 88.56605 0 0 204.69761 -1950.8098 -11480.919 -13574.139 -12190.797 -12798.212 -263.77028 280.62864 1974.1486 + 20 153.91622 -2358.3058 36.396961 66.22466 0 0 102.62162 -1958.8438 -7778.4529 -8492.3868 -11999.431 -9125.9998 -917.99962 589.09064 1788.2094 + 30 145.5951 -2343.9956 39.651541 65.833248 0 0 105.48479 -1957.7184 -288.79965 -2574.4466 -3820.4824 -414.28285 -347.51491 -1147.3995 -126.71025 + 40 126.87801 -2340.2623 102.93951 43.896946 0 0 146.83646 -1948.7309 6766.15 5908.7048 1280.0961 7930.8191 -1085.6811 -1596.6859 -714.82888 + 50 134.52078 -2358.9232 107.49288 44.253826 0 0 151.74671 -1947.7419 8762.4348 6023.4661 5377.0189 9396.0316 -1629.1364 -1663.1666 -2381.51 + 60 173.10181 -2374.3854 51.097314 33.03646 0 0 84.133774 -1956.4102 4614.2907 1719.1989 505.79149 4552.3167 -1661.1714 -587.92108 -1380.6732 + 70 184.86849 -2391.6106 39.916931 35.978152 0 0 75.895083 -1959.1811 -2146.9339 -4993.4021 -4095.6729 -4897.5768 -833.09046 1542.411 -1539.5266 + 80 164.75795 -2406.3017 101.94229 33.067832 0 0 135.01013 -1953.542 -8779.3265 -10545.409 -10418.702 -12098.858 -1319.194 1750.3511 -275.1272 + 90 151.17491 -2434.6876 152.21826 41.301673 0 0 193.51993 -1949.6141 -13330.691 -15436.505 -13791.461 -16934.674 149.25497 2289.1026 976.14333 + +AMEOBA/HIPPO timing info: + Init time: 0.0207283 0.0128038 + Repls time: 0.0699766 4.32242 + Disp time: 0.149724 9.24836 + Mpole time: 0.274572 16.9601 + Induce time: 0.755302 46.6545 + Polar time: 0.336004 20.7548 + Qxfer time: 0.0126115 0.779003 + Total time: 1.61892 + + 100 166.99163 -2452.5298 143.57768 35.341459 0 0 178.91914 -1951.5533 -14918.51 -16077.49 -17353.738 -18140.466 19.009088 1487.0469 1084.0231 +Loop time of 1.64289 on 32 procs for 100 steps with 648 atoms + +Performance: 5.259 ns/day, 4.564 hours/ns, 60.868 timesteps/s +99.7% CPU use with 32 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 1.6154 | 1.62 | 1.6242 | 0.2 | 98.61 +Bond | 0.00017997 | 0.0002499 | 0.00040555 | 0.0 | 0.02 +Neigh | 0.00042001 | 0.00048474 | 0.00059125 | 0.0 | 0.03 +Comm | 0.012961 | 0.017336 | 0.021852 | 1.7 | 1.06 +Output | 0.0036708 | 0.0037324 | 0.0039355 | 0.1 | 0.23 +Modify | 0.0001113 | 0.00018285 | 0.00027874 | 0.0 | 0.01 +Other | | 0.0009209 | | | 0.06 + +Nlocal: 20.25 ave 27 max 12 min +Histogram: 1 1 3 1 6 2 10 4 2 2 +Nghost: 1379.75 ave 1408 max 1345 min +Histogram: 2 4 1 3 3 4 4 3 2 6 +Neighs: 3077.81 ave 4233 max 1858 min +Histogram: 1 3 1 4 5 7 6 2 1 2 + +Total # of neighbors = 98490 +Ave neighs/atom = 151.99074 +Ave special neighs/atom = 2 +Neighbor list builds = 2 +Dangerous builds = 0 +Total wall time: 0:00:01 diff --git a/examples/amoeba/log.water_dimer.amoeba.1.test b/examples/amoeba/log.water_dimer.amoeba.1.test new file mode 100644 index 0000000000..c243c663cc --- /dev/null +++ b/examples/amoeba/log.water_dimer.amoeba.1.test @@ -0,0 +1,150 @@ +LAMMPS (24 Mar 2022) +# water dimer with AMOEBA or HIPPO + +units real +boundary s s s + +atom_style amoeba +bond_style class2 +angle_style amoeba +dihedral_style none + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes +fix extra2 all property/atom i_polaxe + +# read data file + +read_data data.water_dimer.amoeba fix amtype NULL "Tinker Types" +Reading data file ... + orthogonal box = (-1.463996 -0.756549 -0.009705) to (0.933234 0.75612 2.935934) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 6 atoms + scanning bonds ... + 2 = max bonds/atom + scanning angles ... + 1 = max angles/atom + reading bonds ... + 4 bonds + reading angles ... + 2 angles +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + read_data CPU = 0.007 seconds + +# force field + +pair_style amoeba +pair_coeff * * amoeba_water.prm amoeba_water.key + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0.5 0.5 0.5 + special bond factors coul: 0.5 0.5 0.5 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of 1-5 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] + +dump 1 all custom 10 dump.water_dimer id type x y z fx fy fz +dump_modify 1 sort id + +# zero step run + +#run 0 + +# dynamics + +fix 1 all nve + +thermo 10 +run 100 +AMOEBA/HIPPO force field settings + hal: cut 10 taper 8 vscale 0 0 1 1 + multipole: cut 10 aewald 0 mscale 0 0 0.4 1 + polar: cut 10 aewald 0 + pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 1 1 1 1 d/u scale 0 1 + precondition: cut 4.5 + generated 0 of 1 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 12 + ghost atom cutoff = 12 + binsize = 6, bins = 1 1 1 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair amoeba, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d + bin: standard +WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (../domain.cpp:974) + AMOEBA/HIPPO group count: 2 +Per MPI rank memory allocation (min/avg/max) = 9.855 | 9.855 | 9.855 Mbytes + Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] + 0 0 -5.1627563 0.025695395 0.71581114 0 0 0.74150653 -4.4212497 -12260.522 -43226.042 39448.214 -33003.739 -85.160886 -28101.905 -72.971988 + 10 1.1174766 -4.7928792 0.045080327 0.30848527 0 0 0.35356559 -4.4226587 -14728.416 11456.119 -52592.829 -3262.8454 70.868937 29494.268 57.977562 + 20 3.0821934 -5.1387316 0.013108182 0.65694692 0 0 0.6700551 -4.4227393 3007.4148 -25925.326 49641.41 -15284.933 -79.726771 -29005.234 -68.530079 + 30 3.461967 -4.8079248 0.013888863 0.31895667 0 0 0.33284554 -4.423482 8616.211 40027.877 -31134.295 16291.126 72.510013 23088.238 51.407946 + 40 4.2181367 -5.0535921 0.0099009766 0.55796811 0 0 0.56786908 -4.4228557 24239.885 -5761.6967 62095.735 15576.675 -76.240192 -33057.385 -58.850871 + 50 5.216657 -4.8012751 0.0053003148 0.29489399 0 0 0.30019431 -4.4233315 17728.056 44785.731 -21215.714 28613.715 66.24671 20292.137 51.010856 + 60 9.45101 -5.0818046 0.0043357361 0.5118733 0 0 0.51620903 -4.4247372 16893.135 -15068.961 50111.11 13824.77 -75.966047 -34809.168 -52.83183 + 70 10.385926 -4.8250769 0.022572262 0.22235766 0 0 0.24492992 -4.4253547 -1117.3665 19070.918 -36063.612 11648.813 61.067533 25754.59 53.919881 + 80 12.797691 -5.123735 0.023756795 0.48275385 0 0 0.50651065 -4.4264869 -6491.9826 -28436.037 20681.908 -14176.121 -64.024669 -35737.052 -52.583533 + 90 12.569481 -4.8303379 0.060369422 0.15670502 0 0 0.21707444 -4.4259273 -16762.536 1720.5855 -47624.986 -6793.7441 59.966729 30024.566 52.339671 + +AMEOBA/HIPPO timing info: + Init time: 0.000111558 0.0206865 + Hal time: 0.000425262 7.88575 + Mpole time: 0.000608653 11.2864 + Induce time: 0.00283871 52.6391 + Polar time: 0.00139471 25.8625 + Total time: 0.00539279 + + 100 17.750788 -5.1195235 0.039885925 0.38711474 0 0 0.42700067 -4.4279642 -10817.92 -21833.456 4186.8301 -18211.329 -43.11086 -32664.671 -41.508916 +Loop time of 0.00640556 on 1 procs for 100 steps with 6 atoms + +Performance: 1348.828 ns/day, 0.018 hours/ns, 15611.435 timesteps/s +79.3% CPU use with 1 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.0054675 | 0.0054675 | 0.0054675 | 0.0 | 85.36 +Bond | 9.3071e-05 | 9.3071e-05 | 9.3071e-05 | 0.0 | 1.45 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 1.5103e-05 | 1.5103e-05 | 1.5103e-05 | 0.0 | 0.24 +Output | 0.00072279 | 0.00072279 | 0.00072279 | 0.0 | 11.28 +Modify | 4.4005e-05 | 4.4005e-05 | 4.4005e-05 | 0.0 | 0.69 +Other | | 6.307e-05 | | | 0.98 + +Nlocal: 6 ave 6 max 6 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 0 ave 0 max 0 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 15 ave 15 max 15 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 15 +Ave neighs/atom = 2.5 +Ave special neighs/atom = 2 +Neighbor list builds = 0 +Dangerous builds = 0 +Total wall time: 0:00:00 diff --git a/examples/amoeba/log.water_dimer.amoeba.4.test b/examples/amoeba/log.water_dimer.amoeba.4.test new file mode 100644 index 0000000000..9c351d757b --- /dev/null +++ b/examples/amoeba/log.water_dimer.amoeba.4.test @@ -0,0 +1,150 @@ +LAMMPS (24 Mar 2022) +# water dimer with AMOEBA or HIPPO + +units real +boundary s s s + +atom_style amoeba +bond_style class2 +angle_style amoeba +dihedral_style none + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes +fix extra2 all property/atom i_polaxe + +# read data file + +read_data data.water_dimer.amoeba fix amtype NULL "Tinker Types" +Reading data file ... + orthogonal box = (-1.463996 -0.756549 -0.009705) to (0.933234 0.75612 2.935934) + 2 by 1 by 2 MPI processor grid + reading atoms ... + 6 atoms + scanning bonds ... + 2 = max bonds/atom + scanning angles ... + 1 = max angles/atom + reading bonds ... + 4 bonds + reading angles ... + 2 angles +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + read_data CPU = 0.008 seconds + +# force field + +pair_style amoeba +pair_coeff * * amoeba_water.prm amoeba_water.key + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0.5 0.5 0.5 + special bond factors coul: 0.5 0.5 0.5 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of 1-5 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.001 seconds + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] + +dump 1 all custom 10 dump.water_dimer id type x y z fx fy fz +dump_modify 1 sort id + +# zero step run + +#run 0 + +# dynamics + +fix 1 all nve + +thermo 10 +run 100 +AMOEBA/HIPPO force field settings + hal: cut 10 taper 8 vscale 0 0 1 1 + multipole: cut 10 aewald 0 mscale 0 0 0.4 1 + polar: cut 10 aewald 0 + pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 1 1 1 1 d/u scale 0 1 + precondition: cut 4.5 + generated 0 of 1 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 12 + ghost atom cutoff = 12 + binsize = 6, bins = 1 1 1 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair amoeba, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d + bin: standard +WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (../domain.cpp:974) + AMOEBA/HIPPO group count: 2 +Per MPI rank memory allocation (min/avg/max) = 9.883 | 10.02 | 10.15 Mbytes + Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] + 0 0 -5.1627563 0.025695395 0.71581114 0 0 0.74150653 -4.4212497 -12260.522 -43226.042 39448.214 -33003.739 -85.160886 -28101.905 -72.971988 + 10 1.1174766 -4.7928792 0.045080327 0.30848527 0 0 0.35356559 -4.4226587 -14728.416 11456.119 -52592.829 -3262.8454 70.868937 29494.268 57.977562 + 20 3.0821934 -5.1387316 0.013108182 0.65694692 0 0 0.6700551 -4.4227393 3007.4148 -25925.326 49641.41 -15284.933 -79.726771 -29005.234 -68.530079 + 30 3.461967 -4.8079248 0.013888863 0.31895667 0 0 0.33284554 -4.423482 8616.211 40027.877 -31134.295 16291.126 72.510013 23088.238 51.407946 + 40 4.2181367 -5.0535921 0.0099009766 0.55796811 0 0 0.56786908 -4.4228557 24239.885 -5761.6967 62095.735 15576.675 -76.240192 -33057.385 -58.850871 + 50 5.216657 -4.8012751 0.0053003148 0.29489399 0 0 0.30019431 -4.4233315 17728.056 44785.731 -21215.714 28613.715 66.24671 20292.137 51.010856 + 60 9.45101 -5.0818046 0.0043357361 0.5118733 0 0 0.51620903 -4.4247372 16893.135 -15068.961 50111.11 13824.77 -75.966047 -34809.168 -52.83183 + 70 10.385926 -4.8250769 0.022572262 0.22235766 0 0 0.24492992 -4.4253547 -1117.3665 19070.918 -36063.612 11648.813 61.067533 25754.59 53.919881 + 80 12.797691 -5.123735 0.023756795 0.48275385 0 0 0.50651065 -4.4264869 -6491.9826 -28436.037 20681.908 -14176.121 -64.024669 -35737.052 -52.583533 + 90 12.569481 -4.8303379 0.060369422 0.15670502 0 0 0.21707444 -4.4259273 -16762.536 1720.5855 -47624.986 -6793.7441 59.966729 30024.566 52.339671 + +AMEOBA/HIPPO timing info: + Init time: 0.000634572 0.0450252 + Hal time: 0.000117808 0.835889 + Mpole time: 0.000691769 4.90835 + Induce time: 0.0116228 82.4677 + Polar time: 0.0010122 7.18191 + Total time: 0.0140937 + + 100 17.750788 -5.1195235 0.039885925 0.38711474 0 0 0.42700067 -4.4279642 -10817.92 -21833.456 4186.8301 -18211.329 -43.11086 -32664.671 -41.508916 +Loop time of 0.0169629 on 4 procs for 100 steps with 6 atoms + +Performance: 509.347 ns/day, 0.047 hours/ns, 5895.222 timesteps/s +99.4% CPU use with 4 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.014227 | 0.014356 | 0.014521 | 0.1 | 84.63 +Bond | 2.4327e-05 | 5.1278e-05 | 8.6189e-05 | 0.0 | 0.30 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.00067884 | 0.00079493 | 0.00099578 | 0.0 | 4.69 +Output | 0.0011363 | 0.0012476 | 0.0013572 | 0.2 | 7.35 +Modify | 3.5088e-05 | 3.8645e-05 | 4.4792e-05 | 0.0 | 0.23 +Other | | 0.0004741 | | | 2.79 + +Nlocal: 1.5 ave 3 max 0 min +Histogram: 2 0 0 0 0 0 0 0 0 2 +Nghost: 4.5 ave 6 max 3 min +Histogram: 2 0 0 0 0 0 0 0 0 2 +Neighs: 3.75 ave 12 max 0 min +Histogram: 2 0 1 0 0 0 0 0 0 1 + +Total # of neighbors = 15 +Ave neighs/atom = 2.5 +Ave special neighs/atom = 2 +Neighbor list builds = 0 +Dangerous builds = 0 +Total wall time: 0:00:00 diff --git a/examples/amoeba/log.water_dimer.hippo.1.test b/examples/amoeba/log.water_dimer.hippo.1.test new file mode 100644 index 0000000000..a4d1c6b668 --- /dev/null +++ b/examples/amoeba/log.water_dimer.hippo.1.test @@ -0,0 +1,154 @@ +LAMMPS (24 Mar 2022) +# water dimer with AMOEBA or HIPPO + +units real +boundary s s s + +atom_style amoeba +bond_style class2 +angle_style amoeba +dihedral_style none + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes +fix extra2 all property/atom i_polaxe + +# read data file + +read_data data.water_dimer.hippo fix amtype NULL "Tinker Types" +Reading data file ... + orthogonal box = (-1.463996 -0.756549 -0.009705) to (0.933234 0.75612 2.935934) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 6 atoms + scanning bonds ... + 2 = max bonds/atom + scanning angles ... + 1 = max angles/atom + reading bonds ... + 4 bonds + reading angles ... + 2 angles +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + read_data CPU = 0.006 seconds + +# force field + +pair_style hippo +pair_coeff * * hippo_water.prm hippo_water.key + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0.5 0.5 0.5 + special bond factors coul: 0.5 0.5 0.5 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of 1-5 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] + +dump 1 all custom 10 dump.water_dimer id type x y z fx fy fz +dump_modify 1 sort id + +# zero step run + +#run 0 + +# dynamics + +fix 1 all nve + +thermo 10 +run 100 +AMOEBA/HIPPO force field settings + repulsion: cut 10 taper 8 rscale 0 0 1 1 + qxfer: cut 10 taper 8 mscale 0 0 0.4 1 + dispersion: cut 10 aewald 0 dspscale 0 0 0.4 1 + multipole: cut 10 aewald 0 mscale 0 0 0.4 1 + polar: cut 10 aewald 0 + pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 0.2 1 1 1 d/u scale 0 1 + precondition: cut 4.5 + generated 0 of 1 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 12 + ghost atom cutoff = 12 + binsize = 6, bins = 1 1 1 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair hippo, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d + bin: standard +WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (../domain.cpp:974) + AMOEBA/HIPPO group count: 2 +Per MPI rank memory allocation (min/avg/max) = 9.855 | 9.855 | 9.855 Mbytes + Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] + 0 0 -5.0101954 0.025695395 0.51472748 0 0 0.54042288 -4.4697726 -11875.159 -38149.178 29162.678 -26638.977 -70.63422 -24614.614 -58.505595 + 10 0.75132894 -4.7952077 0.028216017 0.28494196 0 0 0.31315798 -4.4708519 -13243.822 12661.254 -49613.657 -2923.1497 69.449413 29456.684 56.087663 + 20 2.1716525 -5.0036265 0.011809223 0.48875837 0 0 0.50056759 -4.4706925 4371.5298 -22102.532 47044.297 -12243.648 -74.588915 -28903.762 -64.48154 + 30 2.9930198 -4.8261906 0.0091463366 0.30162756 0 0 0.3107739 -4.4708086 9992.4549 41973.539 -20985.339 8415.1715 67.458145 25027.414 40.261795 + 40 3.312268 -4.9802484 0.010400667 0.45076258 0 0 0.46116325 -4.4697189 21565.307 -11602.414 65186.215 10476.902 -83.374203 -33222.094 -64.700001 + 50 4.3187397 -4.8535614 0.0060313545 0.31244652 0 0 0.31847788 -4.4707168 11344.244 45839.35 -21073.749 8438.8954 73.345039 29422.636 43.897876 + 60 4.9127902 -5.0035271 0.0070589202 0.45246538 0 0 0.4595243 -4.4707824 6529.9354 -37107.891 46740.24 9015.2973 -90.41111 -34402.095 -53.57079 + 70 5.3145827 -4.8748857 0.025797484 0.29875503 0 0 0.32455252 -4.4711244 -10208.876 26324.134 -49272.688 -8697.2875 84.479942 36185.667 57.000355 + 80 3.8409793 -5.0262066 0.027669388 0.47104466 0 0 0.49871405 -4.4702464 -9777.1809 -52088.554 28053.855 -6033.4555 -94.607853 -44638.417 -59.108505 + 90 3.0683704 -4.8369716 0.035455716 0.28466932 0 0 0.32012503 -4.4711155 -10626.245 31066.635 -49425.925 -14107.889 87.765958 34632.905 52.101981 + +AMEOBA/HIPPO timing info: + Init time: 0.000122127 0.0207713 + Repls time: 0.000661596 11.2524 + Disp time: 0.000406536 6.91434 + Mpole time: 0.00103934 17.677 + Induce time: 0.00224082 38.1118 + Polar time: 0.00123925 21.0772 + Qxfer time: 0.000164716 2.80148 + Total time: 0.00587961 + + 100 3.5262799 -4.9906817 0.016687539 0.45011301 0 0 0.46680055 -4.4713252 5216.7691 -34991.221 43883.163 6082.1058 -95.830393 -48645.129 -64.784334 +Loop time of 0.00703205 on 1 procs for 100 steps with 6 atoms + +Performance: 1228.660 ns/day, 0.020 hours/ns, 14220.604 timesteps/s +94.9% CPU use with 1 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.0059768 | 0.0059768 | 0.0059768 | 0.0 | 84.99 +Bond | 9.2998e-05 | 9.2998e-05 | 9.2998e-05 | 0.0 | 1.32 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 1.7052e-05 | 1.7052e-05 | 1.7052e-05 | 0.0 | 0.24 +Output | 0.00082231 | 0.00082231 | 0.00082231 | 0.0 | 11.69 +Modify | 5.0238e-05 | 5.0238e-05 | 5.0238e-05 | 0.0 | 0.71 +Other | | 7.262e-05 | | | 1.03 + +Nlocal: 6 ave 6 max 6 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 0 ave 0 max 0 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 15 ave 15 max 15 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 15 +Ave neighs/atom = 2.5 +Ave special neighs/atom = 2 +Neighbor list builds = 0 +Dangerous builds = 0 +Total wall time: 0:00:00 diff --git a/examples/amoeba/log.water_dimer.hippo.4.test b/examples/amoeba/log.water_dimer.hippo.4.test new file mode 100644 index 0000000000..6283896e4f --- /dev/null +++ b/examples/amoeba/log.water_dimer.hippo.4.test @@ -0,0 +1,154 @@ +LAMMPS (24 Mar 2022) +# water dimer with AMOEBA or HIPPO + +units real +boundary s s s + +atom_style amoeba +bond_style class2 +angle_style amoeba +dihedral_style none + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes +fix extra2 all property/atom i_polaxe + +# read data file + +read_data data.water_dimer.hippo fix amtype NULL "Tinker Types" +Reading data file ... + orthogonal box = (-1.463996 -0.756549 -0.009705) to (0.933234 0.75612 2.935934) + 2 by 1 by 2 MPI processor grid + reading atoms ... + 6 atoms + scanning bonds ... + 2 = max bonds/atom + scanning angles ... + 1 = max angles/atom + reading bonds ... + 4 bonds + reading angles ... + 2 angles +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + read_data CPU = 0.008 seconds + +# force field + +pair_style hippo +pair_coeff * * hippo_water.prm hippo_water.key + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0.5 0.5 0.5 + special bond factors coul: 0.5 0.5 0.5 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of 1-5 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] + +dump 1 all custom 10 dump.water_dimer id type x y z fx fy fz +dump_modify 1 sort id + +# zero step run + +#run 0 + +# dynamics + +fix 1 all nve + +thermo 10 +run 100 +AMOEBA/HIPPO force field settings + repulsion: cut 10 taper 8 rscale 0 0 1 1 + qxfer: cut 10 taper 8 mscale 0 0 0.4 1 + dispersion: cut 10 aewald 0 dspscale 0 0 0.4 1 + multipole: cut 10 aewald 0 mscale 0 0 0.4 1 + polar: cut 10 aewald 0 + pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 0.2 1 1 1 d/u scale 0 1 + precondition: cut 4.5 + generated 0 of 1 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 12 + ghost atom cutoff = 12 + binsize = 6, bins = 1 1 1 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair hippo, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d + bin: standard +WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (../domain.cpp:974) + AMOEBA/HIPPO group count: 2 +Per MPI rank memory allocation (min/avg/max) = 9.883 | 10.02 | 10.15 Mbytes + Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] + 0 0 -5.0101954 0.025695395 0.51472748 0 0 0.54042288 -4.4697726 -11875.159 -38149.178 29162.678 -26638.977 -70.63422 -24614.614 -58.505595 + 10 0.75132894 -4.7952077 0.028216017 0.28494196 0 0 0.31315798 -4.4708519 -13243.822 12661.254 -49613.657 -2923.1497 69.449413 29456.684 56.087663 + 20 2.1716525 -5.0036265 0.011809223 0.48875837 0 0 0.50056759 -4.4706925 4371.5298 -22102.532 47044.297 -12243.648 -74.588915 -28903.762 -64.48154 + 30 2.9930198 -4.8261906 0.0091463366 0.30162756 0 0 0.3107739 -4.4708086 9992.4549 41973.539 -20985.339 8415.1715 67.458145 25027.414 40.261795 + 40 3.312268 -4.9802484 0.010400667 0.45076258 0 0 0.46116325 -4.4697189 21565.307 -11602.414 65186.215 10476.902 -83.374203 -33222.094 -64.700001 + 50 4.3187397 -4.8535614 0.0060313545 0.31244652 0 0 0.31847788 -4.4707168 11344.244 45839.35 -21073.749 8438.8954 73.345039 29422.636 43.897876 + 60 4.9127902 -5.0035271 0.0070589202 0.45246538 0 0 0.4595243 -4.4707824 6529.9354 -37107.891 46740.24 9015.2973 -90.41111 -34402.095 -53.57079 + 70 5.3145827 -4.8748857 0.025797484 0.29875503 0 0 0.32455252 -4.4711244 -10208.876 26324.134 -49272.688 -8697.2875 84.479942 36185.667 57.000355 + 80 3.8409793 -5.0262066 0.027669388 0.47104466 0 0 0.49871405 -4.4702464 -9777.1809 -52088.554 28053.855 -6033.4555 -94.607853 -44638.417 -59.108505 + 90 3.0683704 -4.8369716 0.035455716 0.28466932 0 0 0.32012503 -4.4711155 -10626.245 31066.635 -49425.925 -14107.889 87.765958 34632.905 52.101981 + +AMEOBA/HIPPO timing info: + Init time: 0.00050652 0.0494826 + Repls time: 0.00054788 5.35232 + Disp time: 9.848e-05 0.962064 + Mpole time: 0.000949974 9.28042 + Induce time: 0.00725514 70.8764 + Polar time: 0.000826552 8.0747 + Qxfer time: 4.75238e-05 0.464266 + Total time: 0.0102363 + + 100 3.5262799 -4.9906817 0.016687539 0.45011301 0 0 0.46680055 -4.4713252 5216.7691 -34991.221 43883.163 6082.1058 -95.830393 -48645.129 -64.784334 +Loop time of 0.0126885 on 4 procs for 100 steps with 6 atoms + +Performance: 680.931 ns/day, 0.035 hours/ns, 7881.149 timesteps/s +98.0% CPU use with 4 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.010297 | 0.010486 | 0.01066 | 0.1 | 82.64 +Bond | 1.5435e-05 | 3.8769e-05 | 6.9606e-05 | 0.0 | 0.31 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.00054274 | 0.00075815 | 0.00091745 | 0.0 | 5.98 +Output | 0.00089374 | 0.00097565 | 0.0010809 | 0.0 | 7.69 +Modify | 2.4069e-05 | 3.143e-05 | 3.8898e-05 | 0.0 | 0.25 +Other | | 0.0003984 | | | 3.14 + +Nlocal: 1.5 ave 3 max 0 min +Histogram: 2 0 0 0 0 0 0 0 0 2 +Nghost: 4.5 ave 6 max 3 min +Histogram: 2 0 0 0 0 0 0 0 0 2 +Neighs: 3.75 ave 12 max 0 min +Histogram: 2 0 1 0 0 0 0 0 0 1 + +Total # of neighbors = 15 +Ave neighs/atom = 2.5 +Ave special neighs/atom = 2 +Neighbor list builds = 0 +Dangerous builds = 0 +Total wall time: 0:00:00 diff --git a/examples/amoeba/log.water_hexamer.amoeba.1.test b/examples/amoeba/log.water_hexamer.amoeba.1.test new file mode 100644 index 0000000000..a866e00da6 --- /dev/null +++ b/examples/amoeba/log.water_hexamer.amoeba.1.test @@ -0,0 +1,149 @@ +LAMMPS (24 Mar 2022) +# water hexamer with AMOEBA or HIPPO + +units real +boundary s s s + +atom_style amoeba +bond_style class2 +angle_style amoeba +dihedral_style none + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes +fix extra2 all property/atom i_polaxe + +# read data file + +read_data data.water_hexamer.amoeba fix amtype NULL "Tinker Types" +Reading data file ... + orthogonal box = (-2.517835 -1.523041 -1.734766) to (2.675716 2.01883 2.220847) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 18 atoms + scanning bonds ... + 2 = max bonds/atom + scanning angles ... + 1 = max angles/atom + reading bonds ... + 12 bonds + reading angles ... + 6 angles +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + read_data CPU = 0.006 seconds + +# force field + +pair_style amoeba +pair_coeff * * amoeba_water.prm amoeba_water.key + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0.5 0.5 0.5 + special bond factors coul: 0.5 0.5 0.5 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of 1-5 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] + +dump 1 all custom 10 dump.water_hexamer id type x y z fx fy fz +dump_modify 1 sort id + +# zero step run + +#run 0 + +# dynamics + +fix 1 all nve + +thermo 10 +run 100 +AMOEBA/HIPPO force field settings + hal: cut 10 taper 8 vscale 0 0 1 1 + multipole: cut 10 aewald 0 mscale 0 0 0.4 1 + polar: cut 10 aewald 0 + pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 1 1 1 1 d/u scale 0 1 + precondition: cut 4.5 + generated 0 of 1 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 12 + ghost atom cutoff = 12 + binsize = 6, bins = 1 1 1 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair amoeba, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d + bin: standard + AMOEBA/HIPPO group count: 6 +Per MPI rank memory allocation (min/avg/max) = 9.804 | 9.804 | 9.804 Mbytes + Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] + 0 0 -48.469664 1.9820353 2.2499329 0 0 4.2319683 -44.237696 -26322.671 -28303.103 -27669.614 -22995.296 1312.6688 2624.8394 4042.0489 + 10 6.3616471 -46.626437 1.7910812 0.25704063 0 0 2.0481218 -44.255947 -23813.06 -24671.886 -17167.34 -30208.043 -474.208 -8339.5934 -5278.359 + 20 15.149798 -48.177533 1.1130818 2.007499 0 0 3.1205807 -44.289255 -16468.855 -20150.975 -18596.629 -12107.083 885.52697 6320.1867 3064.949 + 30 17.896968 -45.959274 0.54802739 0.19519937 0 0 0.74322676 -44.309141 -4749.0624 -9053.7792 -182.37209 -6721.7499 -2003.7641 -627.56998 -1658.1301 + 40 16.203813 -46.840973 0.1371751 1.5793326 0 0 1.7165077 -44.303357 9267.4858 6108.7966 4116.4548 16028.336 380.03787 8468.0648 4492.3331 + 50 11.584975 -45.166711 0.017120512 0.28622888 0 0 0.30334939 -44.276308 22189.511 21453.083 22339.471 21668.607 150.93139 1059.5253 200.0668 + 60 10.002055 -45.994946 0.037889337 1.1987062 0 0 1.2365956 -44.251509 30944.004 35801.925 19832.696 36241.326 2042.3054 2320.5193 1660.0834 + 70 11.272241 -45.411622 0.07431614 0.51778317 0 0 0.59209931 -44.248316 32055.564 39306.193 30181.52 25601.501 1373.4778 -4501.0686 -2570.4767 + 80 14.011502 -46.081444 0.089688317 1.006928 0 0 1.0966163 -44.274812 25661.838 38836.598 12603.734 24205.867 -867.36437 -4211.9639 -2820.6725 + 90 17.659498 -46.247295 0.21744649 0.82687716 0 0 1.0443237 -44.308098 12101.207 19426.995 14142.311 1046.299 -2157.5418 -2141.2454 -2621.456 + +AMEOBA/HIPPO timing info: + Init time: 0.000317854 0.00755342 + Hal time: 0.00509951 12.1184 + Mpole time: 0.0045403 10.7895 + Induce time: 0.0205332 48.7946 + Polar time: 0.0115735 27.503 + Total time: 0.0420808 + + 100 17.630532 -46.788272 0.61811601 0.9654966 0 0 1.5836126 -44.311254 -4455.3587 3961.5737 -11554.095 -7458.8012 -3120.9771 -1532.1706 -1499.0117 +Loop time of 0.0436474 on 1 procs for 100 steps with 18 atoms + +Performance: 197.950 ns/day, 0.121 hours/ns, 2291.090 timesteps/s +98.0% CPU use with 1 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.042165 | 0.042165 | 0.042165 | 0.0 | 96.60 +Bond | 0.00020639 | 0.00020639 | 0.00020639 | 0.0 | 0.47 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 1.9457e-05 | 1.9457e-05 | 1.9457e-05 | 0.0 | 0.04 +Output | 0.0011074 | 0.0011074 | 0.0011074 | 0.0 | 2.54 +Modify | 7.3538e-05 | 7.3538e-05 | 7.3538e-05 | 0.0 | 0.17 +Other | | 7.545e-05 | | | 0.17 + +Nlocal: 18 ave 18 max 18 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 0 ave 0 max 0 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 153 ave 153 max 153 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 153 +Ave neighs/atom = 8.5 +Ave special neighs/atom = 2 +Neighbor list builds = 0 +Dangerous builds = 0 +Total wall time: 0:00:00 diff --git a/examples/amoeba/log.water_hexamer.amoeba.4.test b/examples/amoeba/log.water_hexamer.amoeba.4.test new file mode 100644 index 0000000000..9bc98e71cf --- /dev/null +++ b/examples/amoeba/log.water_hexamer.amoeba.4.test @@ -0,0 +1,150 @@ +LAMMPS (24 Mar 2022) +# water hexamer with AMOEBA or HIPPO + +units real +boundary s s s + +atom_style amoeba +bond_style class2 +angle_style amoeba +dihedral_style none + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes +fix extra2 all property/atom i_polaxe + +# read data file + +read_data data.water_hexamer.amoeba fix amtype NULL "Tinker Types" +Reading data file ... + orthogonal box = (-2.517835 -1.523041 -1.734766) to (2.675716 2.01883 2.220847) + 2 by 1 by 2 MPI processor grid + reading atoms ... + 18 atoms + scanning bonds ... + 2 = max bonds/atom + scanning angles ... + 1 = max angles/atom + reading bonds ... + 12 bonds + reading angles ... + 6 angles +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + read_data CPU = 0.008 seconds + +# force field + +pair_style amoeba +pair_coeff * * amoeba_water.prm amoeba_water.key + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0.5 0.5 0.5 + special bond factors coul: 0.5 0.5 0.5 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of 1-5 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.001 seconds + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] + +dump 1 all custom 10 dump.water_hexamer id type x y z fx fy fz +dump_modify 1 sort id + +# zero step run + +#run 0 + +# dynamics + +fix 1 all nve + +thermo 10 +run 100 +AMOEBA/HIPPO force field settings + hal: cut 10 taper 8 vscale 0 0 1 1 + multipole: cut 10 aewald 0 mscale 0 0 0.4 1 + polar: cut 10 aewald 0 + pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 1 1 1 1 d/u scale 0 1 + precondition: cut 4.5 + generated 0 of 1 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 12 + ghost atom cutoff = 12 + binsize = 6, bins = 1 1 1 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair amoeba, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d + bin: standard +WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (../domain.cpp:974) + AMOEBA/HIPPO group count: 6 +Per MPI rank memory allocation (min/avg/max) = 9.833 | 9.833 | 9.833 Mbytes + Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] + 0 0 -48.469664 1.9820353 2.2499329 0 0 4.2319683 -44.237696 -26322.671 -28303.103 -27669.614 -22995.296 1312.6688 2624.8394 4042.0489 + 10 6.3616471 -46.626437 1.7910812 0.25704063 0 0 2.0481218 -44.255947 -23813.06 -24671.886 -17167.34 -30208.043 -474.208 -8339.5934 -5278.359 + 20 15.149798 -48.177533 1.1130818 2.007499 0 0 3.1205807 -44.289255 -16468.855 -20150.975 -18596.629 -12107.083 885.52697 6320.1867 3064.949 + 30 17.896968 -45.959274 0.54802739 0.19519937 0 0 0.74322676 -44.309141 -4749.0624 -9053.7792 -182.37209 -6721.7499 -2003.7641 -627.56998 -1658.1301 + 40 16.203813 -46.840973 0.1371751 1.5793326 0 0 1.7165077 -44.303357 9267.4858 6108.7966 4116.4548 16028.336 380.03787 8468.0648 4492.3331 + 50 11.584975 -45.166711 0.017120512 0.28622888 0 0 0.30334939 -44.276308 22189.511 21453.083 22339.471 21668.607 150.93139 1059.5253 200.0668 + 60 10.002055 -45.994946 0.037889337 1.1987062 0 0 1.2365956 -44.251509 30944.004 35801.925 19832.696 36241.326 2042.3054 2320.5193 1660.0834 + 70 11.272241 -45.411622 0.07431614 0.51778317 0 0 0.59209931 -44.248316 32055.564 39306.193 30181.52 25601.501 1373.4778 -4501.0686 -2570.4767 + 80 14.011502 -46.081444 0.089688317 1.006928 0 0 1.0966163 -44.274812 25661.838 38836.598 12603.734 24205.867 -867.36437 -4211.9639 -2820.6725 + 90 17.659498 -46.247295 0.21744649 0.82687716 0 0 1.0443237 -44.308098 12101.207 19426.995 14142.311 1046.299 -2157.5418 -2141.2454 -2621.456 + +AMEOBA/HIPPO timing info: + Init time: 0.000876489 0.0216648 + Hal time: 0.0012315 3.04398 + Mpole time: 0.00349354 8.63522 + Induce time: 0.0293642 72.5816 + Polar time: 0.00547642 13.5365 + Total time: 0.0404569 + + 100 17.630532 -46.788272 0.61811601 0.9654966 0 0 1.5836126 -44.311254 -4455.3587 3961.5737 -11554.095 -7458.8012 -3120.9771 -1532.1706 -1499.0117 +Loop time of 0.0431834 on 4 procs for 100 steps with 18 atoms + +Performance: 200.077 ns/day, 0.120 hours/ns, 2315.706 timesteps/s +97.8% CPU use with 4 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.040628 | 0.040702 | 0.04082 | 0.0 | 94.25 +Bond | 7.2822e-05 | 9.4953e-05 | 0.00011572 | 0.0 | 0.22 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.00067844 | 0.00088282 | 0.0010398 | 0.0 | 2.04 +Output | 0.0010464 | 0.0010868 | 0.0011886 | 0.2 | 2.52 +Modify | 4.2857e-05 | 5.2307e-05 | 6.3734e-05 | 0.0 | 0.12 +Other | | 0.0003646 | | | 0.84 + +Nlocal: 4.5 ave 6 max 3 min +Histogram: 1 0 0 1 0 0 1 0 0 1 +Nghost: 13.5 ave 15 max 12 min +Histogram: 1 0 0 1 0 0 1 0 0 1 +Neighs: 38.25 ave 77 max 9 min +Histogram: 2 0 0 0 0 0 1 0 0 1 + +Total # of neighbors = 153 +Ave neighs/atom = 8.5 +Ave special neighs/atom = 2 +Neighbor list builds = 0 +Dangerous builds = 0 +Total wall time: 0:00:00 diff --git a/examples/amoeba/log.water_hexamer.hippo.1.test b/examples/amoeba/log.water_hexamer.hippo.1.test new file mode 100644 index 0000000000..a11319fd33 --- /dev/null +++ b/examples/amoeba/log.water_hexamer.hippo.1.test @@ -0,0 +1,153 @@ +LAMMPS (24 Mar 2022) +# water hexamer with AMOEBA or HIPPO + +units real +boundary s s s + +atom_style amoeba +bond_style class2 +angle_style amoeba +dihedral_style none + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes +fix extra2 all property/atom i_polaxe + +# read data file + +read_data data.water_hexamer.hippo fix amtype NULL "Tinker Types" +Reading data file ... + orthogonal box = (-2.517835 -1.523041 -1.734766) to (2.675716 2.01883 2.220847) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 18 atoms + scanning bonds ... + 2 = max bonds/atom + scanning angles ... + 1 = max angles/atom + reading bonds ... + 12 bonds + reading angles ... + 6 angles +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + read_data CPU = 0.006 seconds + +# force field + +pair_style hippo +pair_coeff * * hippo_water.prm hippo_water.key + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0.5 0.5 0.5 + special bond factors coul: 0.5 0.5 0.5 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of 1-5 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] + +dump 1 all custom 10 dump.water_hexamer id type x y z fx fy fz +dump_modify 1 sort id + +# zero step run + +#run 0 + +# dynamics + +fix 1 all nve + +thermo 10 +run 100 +AMOEBA/HIPPO force field settings + repulsion: cut 10 taper 8 rscale 0 0 1 1 + qxfer: cut 10 taper 8 mscale 0 0 0.4 1 + dispersion: cut 10 aewald 0 dspscale 0 0 0.4 1 + multipole: cut 10 aewald 0 mscale 0 0 0.4 1 + polar: cut 10 aewald 0 + pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 0.2 1 1 1 d/u scale 0 1 + precondition: cut 4.5 + generated 0 of 1 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 12 + ghost atom cutoff = 12 + binsize = 6, bins = 1 1 1 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair hippo, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d + bin: standard + AMOEBA/HIPPO group count: 6 +Per MPI rank memory allocation (min/avg/max) = 9.804 | 9.804 | 9.804 Mbytes + Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] + 0 0 -47.362156 1.9820353 1.6634749 0 0 3.6455102 -43.716646 -34513.768 -42206.078 -31383.641 -29951.584 2850.1184 3579.9253 5768.3698 + 10 11.52238 -45.959856 1.53397 0.085100522 0 0 1.6190706 -43.756903 -28644.676 -34867.94 -19324.955 -32842.522 -370.63233 -6452.0859 -4002.3535 + 20 20.237283 -46.772008 0.54762833 1.3835192 0 0 1.9311476 -43.815361 -10546.356 -10116.359 -17063.425 -6393.701 -1166.7608 4243.6327 3493.9596 + 30 20.666374 -45.011106 0.086797459 0.071122604 0 0 0.15792006 -43.805943 13150.762 15882.022 10964.553 10630.278 -6754.7642 -432.29165 -3783.115 + 40 10.639014 -45.430939 0.18926921 0.96410995 0 0 1.1533792 -43.738441 33402.664 41252.58 19726.586 38211.875 -6166.03 6081.5692 1815.7739 + 50 10.992432 -44.741108 0.19575431 0.25851128 0 0 0.45426559 -43.729815 37696.923 41572.466 33299.43 37168.141 -3254.5134 2.9639226 -1017.3669 + 60 19.748633 -45.461264 0.035287281 0.63217389 0 0 0.66746117 -43.793065 26212.839 28825.788 16048.096 31876.925 3504.5461 135.3505 420.28566 + 70 26.129957 -46.022729 0.30434543 0.56770169 0 0 0.87204711 -43.826579 3919.9866 -2755.6905 11500.428 517.54333 5626.9543 -2238.5786 86.305984 + 80 17.768494 -46.309777 1.1680612 0.45551823 0 0 1.6235794 -43.785801 -18335.898 -22168.789 -14488.992 -20048.346 7343.173 -2646.2196 -2525.6625 + 90 8.3822494 -47.063502 2.0182644 0.88875358 0 0 2.9070179 -43.731724 -33693.203 -43487.996 -15178.35 -43214.494 2412.6411 1993.0113 1780.7512 + +AMEOBA/HIPPO timing info: + Init time: 0.000259847 0.00745584 + Repls time: 0.00547792 15.7179 + Disp time: 0.00244273 7.00898 + Mpole time: 0.00635244 18.2272 + Induce time: 0.0119383 34.2547 + Polar time: 0.00698809 20.051 + Qxfer time: 0.00138825 3.98334 + Total time: 0.0348515 + + 100 8.6486333 -46.517402 1.9551958 0.38696887 0 0 2.3421647 -43.736979 -34734.97 -34372.659 -28372.146 -42286.799 226.18821 40.353457 -755.93912 +Loop time of 0.0363248 on 1 procs for 100 steps with 18 atoms + +Performance: 237.854 ns/day, 0.101 hours/ns, 2752.942 timesteps/s +98.0% CPU use with 1 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.034944 | 0.034944 | 0.034944 | 0.0 | 96.20 +Bond | 0.00016367 | 0.00016367 | 0.00016367 | 0.0 | 0.45 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 1.8118e-05 | 1.8118e-05 | 1.8118e-05 | 0.0 | 0.05 +Output | 0.0010588 | 0.0010588 | 0.0010588 | 0.0 | 2.91 +Modify | 7.1169e-05 | 7.1169e-05 | 7.1169e-05 | 0.0 | 0.20 +Other | | 6.941e-05 | | | 0.19 + +Nlocal: 18 ave 18 max 18 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 0 ave 0 max 0 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 153 ave 153 max 153 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 153 +Ave neighs/atom = 8.5 +Ave special neighs/atom = 2 +Neighbor list builds = 0 +Dangerous builds = 0 +Total wall time: 0:00:00 diff --git a/examples/amoeba/log.water_hexamer.hippo.4.test b/examples/amoeba/log.water_hexamer.hippo.4.test new file mode 100644 index 0000000000..fa89631c2c --- /dev/null +++ b/examples/amoeba/log.water_hexamer.hippo.4.test @@ -0,0 +1,154 @@ +LAMMPS (24 Mar 2022) +# water hexamer with AMOEBA or HIPPO + +units real +boundary s s s + +atom_style amoeba +bond_style class2 +angle_style amoeba +dihedral_style none + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes +fix extra2 all property/atom i_polaxe + +# read data file + +read_data data.water_hexamer.hippo fix amtype NULL "Tinker Types" +Reading data file ... + orthogonal box = (-2.517835 -1.523041 -1.734766) to (2.675716 2.01883 2.220847) + 2 by 1 by 2 MPI processor grid + reading atoms ... + 18 atoms + scanning bonds ... + 2 = max bonds/atom + scanning angles ... + 1 = max angles/atom + reading bonds ... + 12 bonds + reading angles ... + 6 angles +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + read_data CPU = 0.009 seconds + +# force field + +pair_style hippo +pair_coeff * * hippo_water.prm hippo_water.key + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0.5 0.5 0.5 + special bond factors coul: 0.5 0.5 0.5 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of 1-5 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.001 seconds + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] + +dump 1 all custom 10 dump.water_hexamer id type x y z fx fy fz +dump_modify 1 sort id + +# zero step run + +#run 0 + +# dynamics + +fix 1 all nve + +thermo 10 +run 100 +AMOEBA/HIPPO force field settings + repulsion: cut 10 taper 8 rscale 0 0 1 1 + qxfer: cut 10 taper 8 mscale 0 0 0.4 1 + dispersion: cut 10 aewald 0 dspscale 0 0 0.4 1 + multipole: cut 10 aewald 0 mscale 0 0 0.4 1 + polar: cut 10 aewald 0 + pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 0.2 1 1 1 d/u scale 0 1 + precondition: cut 4.5 + generated 0 of 1 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 12 + ghost atom cutoff = 12 + binsize = 6, bins = 1 1 1 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair hippo, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d + bin: standard +WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (../domain.cpp:974) + AMOEBA/HIPPO group count: 6 +Per MPI rank memory allocation (min/avg/max) = 9.833 | 9.833 | 9.833 Mbytes + Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] + 0 0 -47.362156 1.9820353 1.6634749 0 0 3.6455102 -43.716646 -34513.768 -42206.078 -31383.641 -29951.584 2850.1184 3579.9253 5768.3698 + 10 11.52238 -45.959856 1.53397 0.085100522 0 0 1.6190706 -43.756903 -28644.676 -34867.94 -19324.955 -32842.522 -370.63233 -6452.0859 -4002.3535 + 20 20.237283 -46.772008 0.54762833 1.3835192 0 0 1.9311476 -43.815361 -10546.356 -10116.359 -17063.425 -6393.701 -1166.7608 4243.6327 3493.9596 + 30 20.666374 -45.011106 0.086797459 0.071122604 0 0 0.15792006 -43.805943 13150.762 15882.022 10964.553 10630.278 -6754.7642 -432.29165 -3783.115 + 40 10.639014 -45.430939 0.18926921 0.96410995 0 0 1.1533792 -43.738441 33402.664 41252.58 19726.586 38211.875 -6166.03 6081.5692 1815.7739 + 50 10.992432 -44.741108 0.19575431 0.25851128 0 0 0.45426559 -43.729815 37696.923 41572.466 33299.43 37168.141 -3254.5134 2.9639226 -1017.3669 + 60 19.748633 -45.461264 0.035287281 0.63217389 0 0 0.66746117 -43.793065 26212.839 28825.788 16048.096 31876.925 3504.5461 135.3505 420.28566 + 70 26.129957 -46.022729 0.30434543 0.56770169 0 0 0.87204711 -43.826579 3919.9866 -2755.6905 11500.428 517.54333 5626.9543 -2238.5786 86.305984 + 80 17.768494 -46.309777 1.1680612 0.45551823 0 0 1.6235794 -43.785801 -18335.898 -22168.789 -14488.992 -20048.346 7343.173 -2646.2196 -2525.6625 + 90 8.3822494 -47.063502 2.0182644 0.88875358 0 0 2.9070179 -43.731724 -33693.203 -43487.996 -15178.35 -43214.494 2412.6411 1993.0113 1780.7512 + +AMEOBA/HIPPO timing info: + Init time: 0.000745036 0.0228122 + Repls time: 0.00327392 10.0244 + Disp time: 0.000684259 2.09513 + Mpole time: 0.00435168 13.3244 + Induce time: 0.0190657 58.3773 + Polar time: 0.00415392 12.7189 + Qxfer time: 0.000380552 1.16521 + Total time: 0.0326595 + + 100 8.6486333 -46.517402 1.9551958 0.38696887 0 0 2.3421647 -43.736979 -34734.97 -34372.659 -28372.146 -42286.799 226.18821 40.353457 -755.93912 +Loop time of 0.0358657 on 4 procs for 100 steps with 18 atoms + +Performance: 240.899 ns/day, 0.100 hours/ns, 2788.181 timesteps/s +99.9% CPU use with 4 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.032583 | 0.03291 | 0.033445 | 0.2 | 91.76 +Bond | 5.6993e-05 | 8.0508e-05 | 9.8801e-05 | 0.0 | 0.22 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.00070037 | 0.0013312 | 0.0017469 | 1.1 | 3.71 +Output | 0.0010287 | 0.0010873 | 0.0012054 | 0.2 | 3.03 +Modify | 4.2091e-05 | 5.3037e-05 | 6.0581e-05 | 0.0 | 0.15 +Other | | 0.0004036 | | | 1.13 + +Nlocal: 4.5 ave 6 max 3 min +Histogram: 1 0 0 1 0 0 1 0 0 1 +Nghost: 13.5 ave 15 max 12 min +Histogram: 1 0 0 1 0 0 1 0 0 1 +Neighs: 38.25 ave 77 max 9 min +Histogram: 2 0 0 0 0 0 1 0 0 1 + +Total # of neighbors = 153 +Ave neighs/atom = 8.5 +Ave special neighs/atom = 2 +Neighbor list builds = 0 +Dangerous builds = 0 +Total wall time: 0:00:00 diff --git a/src/AMOEBA/amoeba_induce.cpp b/src/AMOEBA/amoeba_induce.cpp index c23e6c4516..a4b7b2e1c6 100644 --- a/src/AMOEBA/amoeba_induce.cpp +++ b/src/AMOEBA/amoeba_induce.cpp @@ -58,21 +58,10 @@ void PairAmoeba::induce() double sum,sump,term; double reduce[4],allreduce[4]; - double *poli; - double **conj,**conjp; - double **vec,**vecp; - double **udir,**usum,**usump; - - int debug = 1; - // set cutoffs, taper coeffs, and PME params - // create qfac here, free at end of polar() - if (use_ewald) { - choose(POLAR_LONG); - int nmine = p_kspace->nfft_owned; - memory->create(qfac,nmine,"ameoba/induce:qfac"); - } else choose(POLAR); + if (use_ewald) choose(POLAR_LONG); + else choose(POLAR); // owned atoms @@ -89,19 +78,6 @@ void PairAmoeba::induce() } } - // allocation of arrays - // NOTE: not all are used by all methods - // NOTE: could be re-allocated dynamically - - memory->create(poli,nlocal,"ameoba/induce:poli"); - memory->create(conj,nlocal,3,"ameoba/induce:conj"); - memory->create(conjp,nlocal,3,"ameoba/induce:conjp"); - memory->create(vec,nlocal,3,"ameoba/induce:vec"); - memory->create(vecp,nlocal,3,"ameoba/induce:vecp"); - memory->create(udir,nlocal,3,"ameoba/induce:udir"); - memory->create(usum,nlocal,3,"ameoba/induce:usum"); - memory->create(usump,nlocal,3,"ameoba/induce:usump"); - // get the electrostatic field due to permanent multipoles dfield0c(field,fieldp); @@ -288,8 +264,6 @@ void PairAmoeba::induce() ufield0c(field,fieldp); - //error->all(FLERR,"STOP"); - crstyle = FIELD; comm->reverse_comm(this); @@ -418,17 +392,6 @@ void PairAmoeba::induce() error->warning(FLERR,"AMOEBA induced dipoles did not converge"); } - // deallocation of arrays - - memory->destroy(poli); - memory->destroy(conj); - memory->destroy(conjp); - memory->destroy(vec); - memory->destroy(vecp); - memory->destroy(udir); - memory->destroy(usum); - memory->destroy(usump); - // update the lists of previous induced dipole values // shift previous m values up to m+1, add new values at m = 0 // only when preconditioner is used @@ -873,26 +836,11 @@ void PairAmoeba::umutual1(double **field, double **fieldp) int nxlo,nxhi,nylo,nyhi,nzlo,nzhi; double term; double a[3][3]; // indices not flipped vs Fortran - double **fuind,**fuinp; - double **fdip_phi1,**fdip_phi2,**fdip_sum_phi; - double **dipfield1,**dipfield2; // return if the Ewald coefficient is zero if (aewald < 1.0e-6) return; - // perform dynamic allocation of some local arrays - // NOTE: avoid reallocation every step? - - int nlocal = atom->nlocal; - memory->create(fuind,nlocal,3,"ameoba/induce:fuind"); - memory->create(fuinp,nlocal,3,"ameoba/induce:fuinp"); - memory->create(fdip_phi1,nlocal,10,"ameoba/induce:fdip_phi1"); - memory->create(fdip_phi2,nlocal,10,"ameoba/induce:fdip_phi2"); - memory->create(fdip_sum_phi,nlocal,20,"ameoba/induce:fdip_dum_phi"); - memory->create(dipfield1,nlocal,3,"ameoba/induce:dipfield1"); - memory->create(dipfield2,nlocal,3,"ameoba/induce:dipfield2"); - // convert Cartesian dipoles to fractional coordinates for (j = 0; j < 3; j++) { @@ -901,6 +849,8 @@ void PairAmoeba::umutual1(double **field, double **fieldp) a[2][j] = nfft3 * recip[2][j]; } + int nlocal = atom->nlocal; + for (i = 0; i < nlocal; i++) { for (j = 0; j < 3; j++) { fuind[i][j] = a[j][0]*uind[i][0] + a[j][1]*uind[i][1] + a[j][2]*uind[i][2]; @@ -991,16 +941,6 @@ void PairAmoeba::umutual1(double **field, double **fieldp) fieldp[i][j] -= dipfield2[i][j]; } } - - // perform deallocation of some local arrays - - memory->destroy(fuind); - memory->destroy(fuinp); - memory->destroy(fdip_phi1); - memory->destroy(fdip_phi2); - memory->destroy(fdip_sum_phi); - memory->destroy(dipfield1); - memory->destroy(dipfield2); } /* ---------------------------------------------------------------------- @@ -1096,16 +1036,6 @@ void PairAmoeba::udirect1(double **field) double volbox = domain->prd[0] * domain->prd[1] * domain->prd[2]; volterm = MY_PI * volbox; - // perform dynamic allocation of 4 Cartesian and fractional arrays - // deallocate in polar - // NOTE: avoid reallocation every step? - - int nlocal = atom->nlocal; - memory->create(cmp,nlocal,10,"ameoba/induce:cmp"); - memory->create(fmp,nlocal,10,"ameoba/induce:fmp"); - memory->create(cphi,nlocal,10,"ameoba/induce:cphi"); - memory->create(fphi,nlocal,20,"ameoba/induce:fphi"); - // FFT moduli pre-computations // set igrid for each atom and its B-spline coeffs @@ -1119,6 +1049,8 @@ void PairAmoeba::udirect1(double **field) // copy the multipole moments into local storage areas + int nlocal = atom->nlocal; + for (i = 0; i < nlocal; i++) { cmp[i][0] = rpole[i][0]; cmp[i][1] = rpole[i][1]; diff --git a/src/AMOEBA/amoeba_kspace.cpp b/src/AMOEBA/amoeba_kspace.cpp index 00ec415c4c..d67fb50b34 100644 --- a/src/AMOEBA/amoeba_kspace.cpp +++ b/src/AMOEBA/amoeba_kspace.cpp @@ -69,7 +69,6 @@ void PairAmoeba::moduli() double x = 0.0; bspline(x,bsorder,array); - //printf("AAA array %f %f %f %f \n",array[0],array[1],array[2],array[3]); for (i = 0; i < maxfft; i++) bsarray[i] = 0.0; for (i = 0; i < bsorder; i++) bsarray[i+1] = array[i]; diff --git a/src/AMOEBA/amoeba_multipole.cpp b/src/AMOEBA/amoeba_multipole.cpp index 3e19f89233..2c666419d1 100644 --- a/src/AMOEBA/amoeba_multipole.cpp +++ b/src/AMOEBA/amoeba_multipole.cpp @@ -89,9 +89,7 @@ void PairAmoeba::multipole() // compute the reciprocal space part of the Ewald summation - //printf("zero check %e \n",empole); if (mpole_kspace_flag) multipole_kspace(); - //printf("kspace energy %e \n",empole); // compute the Ewald self-energy term over all the atoms @@ -376,11 +374,6 @@ void PairAmoeba::multipole_real() alphak = palpha[jclass]; valk = pval[j]; - /* - printf("HIPPO MPOLE ij %d %d: pcore/alpha/val I %g %g %g: J %g %g %g\n", - atom->tag[i],atom->tag[j],corei,alphai,vali,corek,alphak,valk); - */ - term1 = corei*corek; term1i = corek*vali; term2i = corek*dir; @@ -460,28 +453,6 @@ void PairAmoeba::multipole_real() empole += e; - // DEBUG - - /* - count++; - - if (imin == 68 && imax == 1021) { - //printf("AAA %d %d %16.12g\n",imin,imax,e); - printf("AAA %d: %d %d: %d %d: %d: %16.12g\n", - me,atom->tag[i],atom->tag[j],i,j,atom->nlocal,e); - printf("XYZ %g %g %g: %g %g %g\n", - x[i][0],x[i][1],x[i][2],x[j][0],x[j][1],x[j][2]); - } - */ - - /* - if (atom->tag[i] == 1 || atom->tag[j] == 1) { - printf("MPOLE %d %d %d: %15.12g %15.12g %g\n", - atom->tag[i],atom->tag[j],j,r,e,factor_mpole); - printf(" BN: %g %g %g: %g %g %g\n",bn[0],bn[1],bn[2],bn[3],bn[4],bn[5]); - } - */ - // compute the force components for this interaction frcx = de*xr + term1*dix + term2*dkx + term3*(diqkx-dkqix) + @@ -643,14 +614,6 @@ void PairAmoeba::multipole_kspace() felec = electric / am_dielectric; - // perform dynamic allocation of arrays - // NOTE: just do this one time? - - memory->create(cmp,nlocal,10,"ameoba/mpole:cmp"); - memory->create(fmp,nlocal,10,"ameoba/mpole:fmp"); - memory->create(cphi,nlocal,10,"ameoba/mpole:cphi"); - memory->create(fphi,nlocal,20,"ameoba/mpole:fphi"); - // FFT moduli pre-computations // set igrid for each atom and its B-spline coeffs @@ -718,10 +681,6 @@ void PairAmoeba::multipole_kspace() pterm = pow((MY_PI/aewald),2.0); volterm = MY_PI * volbox; - // printf("bsmod1 %e %e %e %e %e %e \n",bsmod1[0],bsmod1[1],bsmod1[2],bsmod1[3],bsmod1[4],bsmod1[5]); - // printf("bsmod2 %e %e %e %e %e %e \n",bsmod2[0],bsmod2[1],bsmod2[2],bsmod2[3],bsmod2[4],bsmod2[5]); - // printf("bsmod3 %e %e %e %e %e %e \n",bsmod3[0],bsmod3[1],bsmod3[2],bsmod3[3],bsmod3[4],bsmod3[5]); - n = 0; for (k = nzlo; k <= nzhi; k++) { for (j = nylo; j <= nyhi; j++) { @@ -729,7 +688,6 @@ void PairAmoeba::multipole_kspace() r1 = (i >= nhalf1) ? i-nfft1 : i; r2 = (j >= nhalf2) ? j-nfft2 : j; r3 = (k >= nhalf3) ? k-nfft3 : k; - //printf("ijk %i %i %i r1r2r3 %f %f %f \n",i,j,k,r1,r2,r3); h1 = recip[0][0]*r1 + recip[0][1]*r2 + recip[0][2]*r3; // matvec h2 = recip[1][0]*r1 + recip[1][1]*r2 + recip[1][2]*r3; h3 = recip[2][0]*r1 + recip[2][1]*r2 + recip[2][2]*r3; @@ -739,7 +697,6 @@ void PairAmoeba::multipole_kspace() if (term > -50.0 && hsq != 0.0) { denom = volterm*hsq*bsmod1[i]*bsmod2[j]*bsmod3[k]; expterm = exp(term) / denom; - //printf("bsmod %e %e %e expterm %e \n",bsmod1[i],bsmod2[j],bsmod3[k],expterm); struc2 = gridfft[n]*gridfft[n] + gridfft[n+1]*gridfft[n+1]; eterm = 0.5 * felec * expterm * struc2; vterm = (2.0/hsq) * (1.0-term) * eterm; @@ -775,8 +732,6 @@ void PairAmoeba::multipole_kspace() fphi_mpole(gridpost,fphi); - //printf("fphi %e %e %e %e \n",fphi[0][0],fphi[0][1],fphi[0][2],fphi[0][3]); - for (i = 0; i < nlocal; i++) { for (k = 0; k < 20; k++) fphi[i][k] *= felec; @@ -882,13 +837,6 @@ void PairAmoeba::multipole_kspace() virmpole[3] -= vxy; virmpole[4] -= vxz; virmpole[5] -= vyz; - - // free local memory - - memory->destroy(cmp); - memory->destroy(fmp); - memory->destroy(cphi); - memory->destroy(fphi); } /* ---------------------------------------------------------------------- diff --git a/src/AMOEBA/amoeba_polar.cpp b/src/AMOEBA/amoeba_polar.cpp index 302121ebc6..e1c90a3f34 100644 --- a/src/AMOEBA/amoeba_polar.cpp +++ b/src/AMOEBA/amoeba_polar.cpp @@ -132,11 +132,6 @@ void PairAmoeba::polar() virpolar[4] -= vxz; virpolar[5] -= vyz; } - - // clean up - // qfac was allocated in induce - - if (use_ewald) memory->destroy(qfac); } /* ---------------------------------------------------------------------- @@ -1260,9 +1255,6 @@ void PairAmoeba::polar_kspace() double cphid[4],cphip[4]; double a[3][3]; // indices not flipped vs Fortran - double **fuind,**fuinp,**fphid,**fphip; - double **fphidp,**cphidp; - // indices into the electrostatic field array // decremented by 1 versus Fortran @@ -1288,17 +1280,6 @@ void PairAmoeba::polar_kspace() felec = electric / am_dielectric; - // dynamic allocation of local arrays - // NOTE: just do this one time? - // NOTE: overlap with induce - - memory->create(fuind,nlocal,3,"polar:fuind"); - memory->create(fuinp,nlocal,3,"polar:fuinp"); - memory->create(fphid,nlocal,10,"polar:fphid"); - memory->create(fphip,nlocal,10,"polar:fphip"); - memory->create(fphidp,nlocal,20,"polar:fphidp"); - memory->create(cphidp,nlocal,10,"polar:cphidp"); - // remove scalar sum virial from prior multipole FFT // can only do this if multipoles were computed with same aeewald = apewald // else need to re-compute it via new long-range solve @@ -1884,11 +1865,8 @@ void PairAmoeba::polar_kspace() gridfft = p_kspace->pre_convolution(); // gridfft1 = copy of first FFT - // NOTE: need to allocate this, when is it freed? - FFT_SCALAR *gridfft1; int nfft_owned = p_kspace->nfft_owned; - memory->create(gridfft1,2*nfft_owned,"amoeba:gridfft1"); memcpy(gridfft1,gridfft,2*nfft_owned*sizeof(FFT_SCALAR)); // assign induced dipoles to the PME grid @@ -1983,7 +1961,6 @@ void PairAmoeba::polar_kspace() double *gridfft = p_kspace->pre_convolution(); // gridfft1 = copy of first FFT - // NOTE: do this same as above int nfft_owned = p_kspace->nfft_owned; memcpy(gridfft1,gridfft,2*nfft_owned*sizeof(double)); @@ -2192,18 +2169,4 @@ void PairAmoeba::polar_kspace() virpolar[3] -= vxy; virpolar[4] -= vxz; virpolar[5] -= vyz; - - // deallocation of local arrays, some from induce - - memory->destroy(gridfft1); - memory->destroy(cmp); - memory->destroy(fmp); - memory->destroy(cphi); - memory->destroy(fphi); - memory->destroy(fuind); - memory->destroy(fuinp); - memory->destroy(fphid); - memory->destroy(fphip); - memory->destroy(fphidp); - memory->destroy(cphidp); } diff --git a/src/AMOEBA/pair_amoeba.cpp b/src/AMOEBA/pair_amoeba.cpp index 8bae12955a..21feb94af8 100644 --- a/src/AMOEBA/pair_amoeba.cpp +++ b/src/AMOEBA/pair_amoeba.cpp @@ -95,12 +95,26 @@ PairAmoeba::PairAmoeba(LAMMPS *lmp) : Pair(lmp) rsd = rsdp = NULL; zrsd = zrsdp = NULL; + cmp = fmp = NULL; + cphi = fphi = NULL; + + poli = NULL; + conj = conjp = NULL; + vec = vecp = NULL; + udir = usum = usump = NULL; + + fuind = fuinp = NULL; + fdip_phi1 = fdip_phi2 = fdip_sum_phi = NULL; + dipfield1 = dipfield2 = NULL; + + fphid = fphip = NULL; + fphidp = cphidp = NULL; + bsordermax = 0; thetai1 = thetai2 = thetai3 = NULL; bsmod1 = bsmod2 = bsmod3 = NULL; bsbuild = NULL; igrid = NULL; - m_kspace = p_kspace = pc_kspace = d_kspace = NULL; i_kspace = ic_kspace = NULL; @@ -117,6 +131,9 @@ PairAmoeba::PairAmoeba(LAMMPS *lmp) : Pair(lmp) firstneigh_pcpc = NULL; dpage_pcpc = NULL; + qfac = NULL; + gridfft1 = NULL; + initialize_type_class(); initialize_vdwl(); initialize_smallsize(); @@ -176,6 +193,7 @@ PairAmoeba::~PairAmoeba() memory->destroy(uoptp); memory->destroy(fopt); memory->destroy(foptp); + memory->destroy(field); memory->destroy(fieldp); memory->destroy(ufld); @@ -185,15 +203,46 @@ PairAmoeba::~PairAmoeba() memory->destroy(zrsd); memory->destroy(zrsdp); + memory->destroy(cmp); + memory->destroy(fmp); + memory->destroy(cphi); + memory->destroy(fphi); + + memory->destroy(poli); + memory->destroy(conj); + memory->destroy(conjp); + memory->destroy(vec); + memory->destroy(vecp); + memory->destroy(udir); + memory->destroy(usum); + memory->destroy(usump); + + memory->destroy(fuind); + memory->destroy(fuinp); + memory->destroy(fdip_phi1); + memory->destroy(fdip_phi2); + memory->destroy(fdip_sum_phi); + memory->destroy(dipfield1); + memory->destroy(dipfield2); + + memory->destroy(fphid); + memory->destroy(fphip); + memory->destroy(fphidp); + memory->destroy(cphidp); + memory->destroy(thetai1); memory->destroy(thetai2); memory->destroy(thetai3); + memory->destroy(igrid); + memory->destroy(bsmod1); memory->destroy(bsmod2); memory->destroy(bsmod3); memory->destroy(bsbuild); - memory->destroy(igrid); + memory->destroy(qfac); + memory->destroy(gridfft1); + delete m_kspace; delete p_kspace; delete pc_kspace; @@ -263,7 +312,7 @@ void PairAmoeba::compute(int eflag, int vflag) // grow local vectors and arrays if necessary - if (atom->nlocal + atom->nghost > nmax) grow_local(); + if (atom->nmax > nmax) grow_local(); // set amtype/amgroup ptrs for rest of compute() to use it @@ -824,6 +873,13 @@ void PairAmoeba::init_style() new AmoebaConvolution(lmp,this,nefft1,nefft2,nefft3,bsporder,INDUCE_GRID); ic_kspace = new AmoebaConvolution(lmp,this,nefft1,nefft2,nefft3,bsporder,INDUCE_GRIDC); + + // qfac is shared by induce and polar + // gridfft1 is copy of FFT grid used within polar + + int nmine = p_kspace->nfft_owned; + memory->create(qfac,nmine,"ameoba/induce:qfac"); + memory->create(gridfft1,2*nmine,"amoeba/polar:gridfft1"); } if (use_dewald) { d_kspace = @@ -2090,43 +2146,17 @@ void *PairAmoeba::extract(const char *str, int &dim) /* ---------------------------------------------------------------------- grow local vectors and arrays if necessary - some need space for ghost atoms, most do not + keep them all atom->nmax in length even if ghost storage not needed ------------------------------------------------------------------------- */ void PairAmoeba::grow_local() { - // only reallocate if nlocal > nmax - - if (atom->nlocal > nmax) { - } - - - - // forward/reverse comm, so ghost values - uind; - uinp; - uopt; - uoptp; - rsd; - rsdp; - xred; // AMOEBA - - memory->destroy(rsd); - memory->destroy(rsdp); - memory->create(rsd,nmax,3,"amoeba:rsd"); - memory->create(rsdp,nmax,3,"amoeba:rsdp"); - - - memory->destroy(rpole); - memory->create(rpole,nmax,13,"amoeba:rpole"); - - - - // free vectors and arrays + // free vectors and arrays memory->destroy(xaxis2local); memory->destroy(yaxis2local); memory->destroy(zaxis2local); + memory->destroy(rpole); memory->destroy(tq); if (amoeba) { @@ -2143,17 +2173,57 @@ void PairAmoeba::grow_local() memory->destroy(fopt); memory->destroy(foptp); } + memory->destroy(field); memory->destroy(fieldp); memory->destroy(ufld); memory->destroy(dufld); + memory->destroy(rsd); + memory->destroy(rsdp); memory->destroy(zrsd); memory->destroy(zrsdp); - memory->destroy(thetai1); - memory->destroy(thetai2); - memory->destroy(thetai3); - memory->destroy(igrid); + // multipole + + memory->destroy(cmp); + memory->destroy(fmp); + memory->destroy(cphi); + memory->destroy(fphi); + + // induce + + memory->destroy(poli); + memory->destroy(conj); + memory->destroy(conjp); + memory->destroy(vec); + memory->destroy(vecp); + memory->destroy(udir); + memory->destroy(usum); + memory->destroy(usump); + + memory->destroy(fuind); + memory->destroy(fuinp); + memory->destroy(fdip_phi1); + memory->destroy(fdip_phi2); + memory->destroy(fdip_sum_phi); + memory->destroy(dipfield1); + memory->destroy(dipfield2); + + // polar + + memory->destroy(fphid); + memory->destroy(fphip); + memory->destroy(fphidp); + memory->destroy(cphidp); + + if (use_ewald || use_dewald) { + memory->destroy(thetai1); + memory->destroy(thetai2); + memory->destroy(thetai3); + memory->destroy(igrid); + } + + // dipole and PCG neighbor lists memory->destroy(numneigh_dipole); memory->sfree(firstneigh_dipole); @@ -2170,11 +2240,11 @@ void PairAmoeba::grow_local() nmax = atom->nmax; // re-allocate vectors and arrays - // note use of optorder+1 for uopt and uoptp memory->create(xaxis2local,nmax,"amoeba:xaxis2local"); memory->create(yaxis2local,nmax,"amoeba:yaxis2local"); memory->create(zaxis2local,nmax,"amoeba:zaxis2local"); + memory->create(rpole,nmax,13,"amoeba:rpole"); memory->create(tq,nmax,3,"amoeba:tq"); if (amoeba) { @@ -2182,6 +2252,8 @@ void PairAmoeba::grow_local() memory->create(xred,nmax,3,"amoeba:xred"); } + // note use of optorder+1 for uopt and uoptp + memory->create(uind,nmax,3,"amoeba:uind"); memory->create(uinp,nmax,3,"amoeba:uinp"); memory->create(udirp,nmax,3,"amoeba:uinp"); @@ -2191,13 +2263,49 @@ void PairAmoeba::grow_local() memory->create(fopt,nmax,optorder,10,"amoeba:fopt"); memory->create(foptp,nmax,optorder,10,"amoeba:foptp"); } + memory->create(field,nmax,3,"amoeba:field"); memory->create(fieldp,nmax,3,"amoeba:fieldp"); memory->create(ufld,nmax,3,"amoeba:ufld"); memory->create(dufld,nmax,6,"amoeba:dufld"); + memory->create(rsd,nmax,3,"amoeba:rsd"); + memory->create(rsdp,nmax,3,"amoeba:rsdp"); memory->create(zrsd,nmax,3,"amoeba:zrsd"); memory->create(zrsdp,nmax,3,"amoeba:zrsdp"); + // multipole + + memory->create(cmp,nmax,10,"ameoba/mpole:cmp"); + memory->create(fmp,nmax,10,"ameoba/mpole:fmp"); + memory->create(cphi,nmax,10,"ameoba/mpole:cphi"); + memory->create(fphi,nmax,20,"ameoba/mpole:fphi"); + + // induce + + memory->create(poli,nmax,"ameoba/induce:poli"); + memory->create(conj,nmax,3,"ameoba/induce:conj"); + memory->create(conjp,nmax,3,"ameoba/induce:conjp"); + memory->create(vec,nmax,3,"ameoba/induce:vec"); + memory->create(vecp,nmax,3,"ameoba/induce:vecp"); + memory->create(udir,nmax,3,"ameoba/induce:udir"); + memory->create(usum,nmax,3,"ameoba/induce:usum"); + memory->create(usump,nmax,3,"ameoba/induce:usump"); + + memory->create(fuind,nmax,3,"ameoba/induce:fuind"); + memory->create(fuinp,nmax,3,"ameoba/induce:fuinp"); + memory->create(fdip_phi1,nmax,10,"ameoba/induce:fdip_phi1"); + memory->create(fdip_phi2,nmax,10,"ameoba/induce:fdip_phi2"); + memory->create(fdip_sum_phi,nmax,20,"ameoba/induce:fdip_dum_phi"); + memory->create(dipfield1,nmax,3,"ameoba/induce:dipfield1"); + memory->create(dipfield2,nmax,3,"ameoba/induce:dipfield2"); + + // polar + + memory->create(fphid,nmax,10,"polar:fphid"); + memory->create(fphip,nmax,10,"polar:fphip"); + memory->create(fphidp,nmax,20,"polar:fphidp"); + memory->create(cphidp,nmax,10,"polar:cphidp"); + if (use_ewald || use_dewald) { memory->create(thetai1,nmax,bsordermax,4,"amoeba:thetai1"); memory->create(thetai2,nmax,bsordermax,4,"amoeba:thetai2"); @@ -2220,3 +2328,68 @@ void PairAmoeba::grow_local() } } +/* ---------------------------------------------------------------------- + memory usage of local atom-based arrays and FFTs +------------------------------------------------------------------------- */ + +double PairAmoeba::memory_usage() +{ + double bytes = 0.0; + + bytes += (double) 3 * nmax * sizeof(int); // xyz axis2local + bytes += (double) 13 * nmax * sizeof(double); // rpole + bytes += (double) 3 * nmax * sizeof(double); // tq + + if (amoeba) { + bytes += (double) nmax * sizeof(int); // red22local + bytes += (double) 3 * nmax * sizeof(double); // xred + } + + bytes += (double) 9 * nmax * sizeof(double); // uind/uinp/udirp + if (poltyp == OPT) { + bytes += (double) 6 * (optorder+1) * nmax * sizeof(double); // uopt/uoptp + bytes += (double) 20 * optorder * nmax * sizeof(double); // fopt/foptp + } + + bytes += (double) 15 * nmax * sizeof(double); // field/fieldp/ufld/dufld + bytes += (double) 12 * nmax * sizeof(double); // rsd/rsdp/zrsd/zrsdp + + bytes += (double) 50 * nmax * sizeof(double); // cmp/fmp/cphi/fphi + + bytes += (double) nmax * sizeof(double); // poli + bytes += (double) 12 * nmax * sizeof(double); // conj/conjp/vec/vecp + bytes += (double) 9 * nmax * sizeof(double); // udir/usum/usump + + bytes += (double) 6 * nmax * sizeof(double); // fuind/fuinp + bytes += (double) 20 * nmax * sizeof(double); // fdip_phi1/fdip_phi1 + bytes += (double) 20 * nmax * sizeof(double); // fdip_sum_phi + bytes += (double) 6 * nmax * sizeof(double); // dipfield1/dipfield2 + + bytes += (double) 50 * nmax * sizeof(double); // fphid/fphip/fphidp/cphidp + + if (use_ewald || use_dewald) { + bytes += (double) 12 * bsordermax * nmax *sizeof(double); // theta123 + bytes += (double) 3 * nmax *sizeof(int); // igrid + } + + bytes += (double) nmax * sizeof(int); // numneigh_dipole + bytes += (double) nmax * sizeof(int *); // firstneigh_dipole + bytes += (double) nmax * sizeof(double *); // firstneigh_dipdip + for (int i = 0; i < comm->nthreads; i++) { // 2 neighbor lists + bytes += ipage_dipole[i].size(); + bytes += dpage_dipdip[i].size(); + } + + if (poltyp == MUTUAL && pcgprec) { + bytes += (double) nmax * sizeof(int); // numneigh_rpecond + bytes += (double) nmax * sizeof(int *); // firstneigh_precond + bytes += (double) nmax * sizeof(double *); // firstneigh_pcpc + for (int i = 0; i < comm->nthreads; i++) { // 2 neighbor lists + bytes += ipage_precond[i].size(); + bytes += dpage_pcpc[i].size(); + } + } + + return bytes; +} + diff --git a/src/AMOEBA/pair_amoeba.h b/src/AMOEBA/pair_amoeba.h index 5de382e2d9..f557f81772 100644 --- a/src/AMOEBA/pair_amoeba.h +++ b/src/AMOEBA/pair_amoeba.h @@ -58,6 +58,7 @@ class PairAmoeba : public Pair { void unpack_reverse_grid(int, void *, int, int *); void *extract(const char *, int &); + double memory_usage(); protected: int me,nprocs; @@ -267,6 +268,18 @@ class PairAmoeba : public Pair { double ***fopt,***foptp; // computed in induce, used by polar, if OPT // Nlocal x optorder x 10 + double *poli; + double **conj,**conjp; + double **vec,**vecp; + double **udir,**usum,**usump; + + double **fuind,**fuinp; + double **fdip_phi1,**fdip_phi2,**fdip_sum_phi; + double **dipfield1,**dipfield2; + + double **fphid,**fphip; + double **fphidp,**cphidp; + // derived local neighbor lists int *numneigh_dipole; // number of dipole neighs for each atom @@ -314,8 +327,11 @@ class PairAmoeba : public Pair { // Kspace data for induce and polar - double *qfac; // convoulution pre-factors - double **cmp,**fmp,**cphi,**fphi; // Cartesian and fractional multipoles + double *qfac; // convoulution pre-factors + double *gridfft1; // copy of p_kspace FFT grid + + double **cmp,**fmp; // Cartesian and fractional multipoles + double **cphi,**fphi; // params for current KSpace solve and FFT being worked on From df2ecf5bf8c2f033832fe818e173832eddda8f7f Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Wed, 18 May 2022 08:49:31 -0600 Subject: [PATCH 164/585] timings, energy, virial tallying --- src/AMOEBA/amoeba_charge_transfer.cpp | 31 +++--- src/AMOEBA/amoeba_dispersion.cpp | 55 ++++++----- src/AMOEBA/amoeba_hal.cpp | 31 +++--- src/AMOEBA/amoeba_multipole.cpp | 131 +++++++++++++------------- src/AMOEBA/amoeba_polar.cpp | 53 ++++++----- src/AMOEBA/amoeba_repulsion.cpp | 42 +++------ src/AMOEBA/pair_amoeba.cpp | 117 +++++++++++------------ src/AMOEBA/pair_amoeba.h | 1 + src/finish.cpp | 5 + src/pair.h | 1 + src/pair_hybrid.cpp | 6 ++ src/pair_hybrid.h | 1 + 12 files changed, 230 insertions(+), 244 deletions(-) diff --git a/src/AMOEBA/amoeba_charge_transfer.cpp b/src/AMOEBA/amoeba_charge_transfer.cpp index 3ab5171d93..a0928e1e63 100644 --- a/src/AMOEBA/amoeba_charge_transfer.cpp +++ b/src/AMOEBA/amoeba_charge_transfer.cpp @@ -148,25 +148,20 @@ void PairAmoeba::charge_transfer() // increment the internal virial tensor components - vxx = xr * frcx; - vxy = yr * frcx; - vxz = zr * frcx; - vyy = yr * frcy; - vyz = zr * frcy; - vzz = zr * frcz; + if (vflag_global) { + vxx = xr * frcx; + vxy = yr * frcx; + vxz = zr * frcx; + vyy = yr * frcy; + vyz = zr * frcy; + vzz = zr * frcz; - virqxfer[0] -= vxx; - virqxfer[1] -= vyy; - virqxfer[2] -= vzz; - virqxfer[3] -= vxy; - virqxfer[4] -= vxz; - virqxfer[5] -= vyz; - - // energy = e - // virial = 6-vec vir - // NOTE: add tally function - - if (evflag) { + virqxfer[0] -= vxx; + virqxfer[1] -= vyy; + virqxfer[2] -= vzz; + virqxfer[3] -= vxy; + virqxfer[4] -= vxz; + virqxfer[5] -= vyz; } } } diff --git a/src/AMOEBA/amoeba_dispersion.cpp b/src/AMOEBA/amoeba_dispersion.cpp index 5dd7aacc88..83405cfab9 100644 --- a/src/AMOEBA/amoeba_dispersion.cpp +++ b/src/AMOEBA/amoeba_dispersion.cpp @@ -212,25 +212,20 @@ void PairAmoeba::dispersion_real() // increment the internal virial tensor components - vxx = xr * dedx; - vyx = yr * dedx; - vzx = zr * dedx; - vyy = yr * dedy; - vzy = zr * dedy; - vzz = zr * dedz; + if (vflag_global) { + vxx = xr * dedx; + vyx = yr * dedx; + vzx = zr * dedx; + vyy = yr * dedy; + vzy = zr * dedy; + vzz = zr * dedz; - virdisp[0] -= vxx; - virdisp[1] -= vyy; - virdisp[2] -= vzz; - virdisp[3] -= vyx; - virdisp[4] -= vzx; - virdisp[5] -= vzy; - - // energy = e - // virial = 6-vec vir - // NOTE: add tally function - - if (evflag) { + virdisp[0] -= vxx; + virdisp[1] -= vyy; + virdisp[2] -= vzz; + virdisp[3] -= vyx; + virdisp[4] -= vzx; + virdisp[5] -= vzy; } } } @@ -350,13 +345,15 @@ void PairAmoeba::dispersion_kspace() struc2 = gridfft[n]*gridfft[n] + gridfft[n+1]*gridfft[n+1]; e = -(term1 / denom) * struc2; edisp += e; - vterm = 3.0 * (fac1*erfcterm*h + fac3*expterm) * struc2/denom; - virdisp[0] -= h1*h1*vterm - e; - virdisp[1] -= h2*h2*vterm - e; - virdisp[2] -= h3*h3*vterm - e; - virdisp[3] -= h1*h2*vterm; - virdisp[4] -= h1*h3*vterm; - virdisp[5] -= h2*h3*vterm; + if (vflag_global) { + vterm = 3.0 * (fac1*erfcterm*h + fac3*expterm) * struc2/denom; + virdisp[0] -= h1*h1*vterm - e; + virdisp[1] -= h2*h2*vterm - e; + virdisp[2] -= h3*h3*vterm - e; + virdisp[3] -= h1*h2*vterm; + virdisp[4] -= h1*h3*vterm; + virdisp[5] -= h2*h3*vterm; + } } else term1 = 0.0; // NOTE: pre-calc this division only once gridfft[n] *= -(term1/denom); @@ -418,8 +415,10 @@ void PairAmoeba::dispersion_kspace() if (me == 0) { edisp -= term; - virdisp[0] -= term; - virdisp[1] -= term; - virdisp[2] -= term; + if (vflag_global) { + virdisp[0] -= term; + virdisp[1] -= term; + virdisp[2] -= term; + } } } diff --git a/src/AMOEBA/amoeba_hal.cpp b/src/AMOEBA/amoeba_hal.cpp index 561a2869a2..d73a24ab21 100644 --- a/src/AMOEBA/amoeba_hal.cpp +++ b/src/AMOEBA/amoeba_hal.cpp @@ -188,25 +188,20 @@ void PairAmoeba::hal() // increment the internal virial tensor components - vxx = xr * dedx; - vyx = yr * dedx; - vzx = zr * dedx; - vyy = yr * dedy; - vzy = zr * dedy; - vzz = zr * dedz; + if (vflag_global) { + vxx = xr * dedx; + vyx = yr * dedx; + vzx = zr * dedx; + vyy = yr * dedy; + vzy = zr * dedy; + vzz = zr * dedz; - virhal[0] -= vxx; - virhal[1] -= vyy; - virhal[2] -= vzz; - virhal[3] -= vyx; - virhal[4] -= vzx; - virhal[5] -= vzy; - - // energy = e - // virial = 6-vec vir - // NOTE: add tally function - - if (evflag) { + virhal[0] -= vxx; + virhal[1] -= vyy; + virhal[2] -= vzz; + virhal[3] -= vyx; + virhal[4] -= vzx; + virhal[5] -= vzy; } } } diff --git a/src/AMOEBA/amoeba_multipole.cpp b/src/AMOEBA/amoeba_multipole.cpp index 2c666419d1..faf54584c6 100644 --- a/src/AMOEBA/amoeba_multipole.cpp +++ b/src/AMOEBA/amoeba_multipole.cpp @@ -497,25 +497,20 @@ void PairAmoeba::multipole_real() // increment the virial due to pairwise Cartesian forces - vxx = -xr * frcx; - vxy = -0.5 * (yr*frcx+xr*frcy); - vxz = -0.5 * (zr*frcx+xr*frcz); - vyy = -yr * frcy; - vyz = -0.5 * (zr*frcy+yr*frcz); - vzz = -zr * frcz; - - virmpole[0] -= vxx; - virmpole[1] -= vyy; - virmpole[2] -= vzz; - virmpole[3] -= vxy; - virmpole[4] -= vxz; - virmpole[5] -= vyz; - - // energy = e - // virial = 6-vec vir - // NOTE: add tally function - - if (evflag) { + if (vflag_global) { + vxx = -xr * frcx; + vxy = -0.5 * (yr*frcx+xr*frcy); + vxz = -0.5 * (zr*frcx+xr*frcz); + vyy = -yr * frcy; + vyz = -0.5 * (zr*frcy+yr*frcz); + vzz = -zr * frcz; + + virmpole[0] -= vxx; + virmpole[1] -= vyy; + virmpole[2] -= vzz; + virmpole[3] -= vxy; + virmpole[4] -= vxz; + virmpole[5] -= vyz; } } } @@ -530,6 +525,8 @@ void PairAmoeba::multipole_real() for (i = 0; i < nlocal; i++) { torque2force(i,tq[i],fix,fiy,fiz,f); + if (!vflag_global) continue; + iz = zaxis2local[i]; ix = xaxis2local[i]; iy = yaxis2local[i]; @@ -543,7 +540,7 @@ void PairAmoeba::multipole_real() xiy = x[iy][0] - x[i][0]; yiy = x[iy][1] - x[i][1]; ziy = x[iy][2] - x[i][2]; - + vxx = xix*fix[0] + xiy*fiy[0] + xiz*fiz[0]; vxy = 0.5 * (yix*fix[0] + yiy*fiy[0] + yiz*fiz[0] + xix*fix[1] + xiy*fiy[1] + xiz*fiz[1]); @@ -553,7 +550,7 @@ void PairAmoeba::multipole_real() vyz = 0.5 * (zix*fix[1] + ziy*fiy[1] + ziz*fiz[1] + yix*fix[2] + yiy*fiy[2] + yiz*fiz[2]); vzz = zix*fix[2] + ziy*fiy[2] + ziz*fiz[2]; - + virmpole[0] -= vxx; virmpole[1] -= vyy; virmpole[2] -= vzz; @@ -768,22 +765,24 @@ void PairAmoeba::multipole_kspace() // augment the permanent multipole virial contributions - for (i = 0; i < nlocal; i++) { - vxx = vxx - cmp[i][1]*cphi[i][1] - 2.0*cmp[i][4]*cphi[i][4] - - cmp[i][7]*cphi[i][7] - cmp[i][8]*cphi[i][8]; - vxy = vxy - 0.5*(cmp[i][2]*cphi[i][1]+cmp[i][1]*cphi[i][2]) - - (cmp[i][4]+cmp[i][5])*cphi[i][7] - 0.5*cmp[i][7]*(cphi[i][4]+cphi[i][5]) - - 0.5*(cmp[i][8]*cphi[i][9]+cmp[i][9]*cphi[i][8]); - vxz = vxz - 0.5*(cmp[i][3]*cphi[i][1]+cmp[i][1]*cphi[i][3]) - - (cmp[i][4]+cmp[i][6])*cphi[i][8] - 0.5*cmp[i][8]*(cphi[i][4]+cphi[i][6]) - - 0.5*(cmp[i][7]*cphi[i][9]+cmp[i][9]*cphi[i][7]); - vyy = vyy - cmp[i][2]*cphi[i][2] - 2.0*cmp[i][5]*cphi[i][5] - - cmp[i][7]*cphi[i][7] - cmp[i][9]*cphi[i][9]; - vyz = vyz - 0.5*(cmp[i][3]*cphi[i][2]+cmp[i][2]*cphi[i][3]) - - (cmp[i][5]+cmp[i][6])*cphi[i][9] - 0.5*cmp[i][9]*(cphi[i][5]+cphi[i][6]) - - 0.5*(cmp[i][7]*cphi[i][8]+cmp[i][8]*cphi[i][7]); - vzz = vzz - cmp[i][3]*cphi[i][3] - 2.0*cmp[i][6]*cphi[i][6] - - cmp[i][8]*cphi[i][8] - cmp[i][9]*cphi[i][9]; + if (vflag_global) { + for (i = 0; i < nlocal; i++) { + vxx = vxx - cmp[i][1]*cphi[i][1] - 2.0*cmp[i][4]*cphi[i][4] - + cmp[i][7]*cphi[i][7] - cmp[i][8]*cphi[i][8]; + vxy = vxy - 0.5*(cmp[i][2]*cphi[i][1]+cmp[i][1]*cphi[i][2]) - + (cmp[i][4]+cmp[i][5])*cphi[i][7] - 0.5*cmp[i][7]*(cphi[i][4]+cphi[i][5]) - + 0.5*(cmp[i][8]*cphi[i][9]+cmp[i][9]*cphi[i][8]); + vxz = vxz - 0.5*(cmp[i][3]*cphi[i][1]+cmp[i][1]*cphi[i][3]) - + (cmp[i][4]+cmp[i][6])*cphi[i][8] - 0.5*cmp[i][8]*(cphi[i][4]+cphi[i][6]) - + 0.5*(cmp[i][7]*cphi[i][9]+cmp[i][9]*cphi[i][7]); + vyy = vyy - cmp[i][2]*cphi[i][2] - 2.0*cmp[i][5]*cphi[i][5] - + cmp[i][7]*cphi[i][7] - cmp[i][9]*cphi[i][9]; + vyz = vyz - 0.5*(cmp[i][3]*cphi[i][2]+cmp[i][2]*cphi[i][3]) - + (cmp[i][5]+cmp[i][6])*cphi[i][9] - 0.5*cmp[i][9]*(cphi[i][5]+cphi[i][6]) - + 0.5*(cmp[i][7]*cphi[i][8]+cmp[i][8]*cphi[i][7]); + vzz = vzz - cmp[i][3]*cphi[i][3] - 2.0*cmp[i][6]*cphi[i][6] - + cmp[i][8]*cphi[i][8] - cmp[i][9]*cphi[i][9]; + } } // resolve site torques then increment forces and virial @@ -804,39 +803,43 @@ void PairAmoeba::multipole_kspace() torque2force(i,tem,fix,fiy,fiz,f); - iz = zaxis2local[i]; - ix = xaxis2local[i]; - iy = yaxis2local[i]; + if (vflag_global) { + iz = zaxis2local[i]; + ix = xaxis2local[i]; + iy = yaxis2local[i]; - xiz = x[iz][0] - x[i][0]; - yiz = x[iz][1] - x[i][1]; - ziz = x[iz][2] - x[i][2]; - xix = x[ix][0] - x[i][0]; - yix = x[ix][1] - x[i][1]; - zix = x[ix][2] - x[i][2]; - xiy = x[iy][0] - x[i][0]; - yiy = x[iy][1] - x[i][1]; - ziy = x[iy][2] - x[i][2]; + xiz = x[iz][0] - x[i][0]; + yiz = x[iz][1] - x[i][1]; + ziz = x[iz][2] - x[i][2]; + xix = x[ix][0] - x[i][0]; + yix = x[ix][1] - x[i][1]; + zix = x[ix][2] - x[i][2]; + xiy = x[iy][0] - x[i][0]; + yiy = x[iy][1] - x[i][1]; + ziy = x[iy][2] - x[i][2]; - vxx += xix*fix[0] + xiy*fiy[0] + xiz*fiz[0]; - vxy += 0.5*(yix*fix[0] + yiy*fiy[0] + yiz*fiz[0] + - xix*fix[1] + xiy*fiy[1] + xiz*fiz[1]); - vxz += 0.5*(zix*fix[0] + ziy*fiy[0] + ziz*fiz[0] + - xix*fix[2] + xiy*fiy[2] + xiz*fiz[2]); - vyy += yix*fix[1] + yiy*fiy[1] + yiz*fiz[1]; - vyz += 0.5*(zix*fix[1] + ziy*fiy[1] + ziz*fiz[1] + - yix*fix[2] + yiy*fiy[2] + yiz*fiz[2]); - vzz += zix*fix[2] + ziy*fiy[2] + ziz*fiz[2]; + vxx += xix*fix[0] + xiy*fiy[0] + xiz*fiz[0]; + vxy += 0.5*(yix*fix[0] + yiy*fiy[0] + yiz*fiz[0] + + xix*fix[1] + xiy*fiy[1] + xiz*fiz[1]); + vxz += 0.5*(zix*fix[0] + ziy*fiy[0] + ziz*fiz[0] + + xix*fix[2] + xiy*fiy[2] + xiz*fiz[2]); + vyy += yix*fix[1] + yiy*fiy[1] + yiz*fiz[1]; + vyz += 0.5*(zix*fix[1] + ziy*fiy[1] + ziz*fiz[1] + + yix*fix[2] + yiy*fiy[2] + yiz*fiz[2]); + vzz += zix*fix[2] + ziy*fiy[2] + ziz*fiz[2]; + } } // increment total internal virial tensor components - virmpole[0] -= vxx; - virmpole[1] -= vyy; - virmpole[2] -= vzz; - virmpole[3] -= vxy; - virmpole[4] -= vxz; - virmpole[5] -= vyz; + if (vflag_global) { + virmpole[0] -= vxx; + virmpole[1] -= vyy; + virmpole[2] -= vzz; + virmpole[3] -= vxy; + virmpole[4] -= vxz; + virmpole[5] -= vyz; + } } /* ---------------------------------------------------------------------- diff --git a/src/AMOEBA/amoeba_polar.cpp b/src/AMOEBA/amoeba_polar.cpp index e1c90a3f34..75acd402f9 100644 --- a/src/AMOEBA/amoeba_polar.cpp +++ b/src/AMOEBA/amoeba_polar.cpp @@ -100,6 +100,8 @@ void PairAmoeba::polar() torque2force(i,tep,fix,fiy,fiz,f); + if (!vflag_global) continue; + iz = zaxis2local[i]; ix = xaxis2local[i]; iy = yaxis2local[i]; @@ -113,7 +115,7 @@ void PairAmoeba::polar() xiy = x[iy][0] - x[i][0]; yiy = x[iy][1] - x[i][1]; ziy = x[iy][2] - x[i][2]; - + vxx = xix*fix[0] + xiy*fiy[0] + xiz*fiz[0]; vyy = yix*fix[1] + yiy*fiy[1] + yiz*fiz[1]; vzz = zix*fix[2] + ziy*fiy[2] + ziz*fiz[2]; @@ -124,7 +126,7 @@ void PairAmoeba::polar() xix*fix[2] + xiy*fiy[2] + xiz*fiz[2]); vyz = 0.5 * (zix*fix[1] + ziy*fiy[1] + ziz*fiz[1] + yix*fix[2] + yiy*fiy[2] + yiz*fiz[2]); - + virpolar[0] -= vxx; virpolar[1] -= vyy; virpolar[2] -= vzz; @@ -1139,25 +1141,20 @@ void PairAmoeba::polar_real() // increment the virial due to pairwise Cartesian forces - vxx = xr * frcx; - vxy = 0.5 * (yr*frcx+xr*frcy); - vxz = 0.5 * (zr*frcx+xr*frcz); - vyy = yr * frcy; - vyz = 0.5 * (zr*frcy+yr*frcz); - vzz = zr * frcz; + if (vflag_global) { + vxx = xr * frcx; + vxy = 0.5 * (yr*frcx+xr*frcy); + vxz = 0.5 * (zr*frcx+xr*frcz); + vyy = yr * frcy; + vyz = 0.5 * (zr*frcy+yr*frcz); + vzz = zr * frcz; - virpolar[0] -= vxx; - virpolar[1] -= vyy; - virpolar[2] -= vzz; - virpolar[3] -= vxy; - virpolar[4] -= vxz; - virpolar[5] -= vyz; - - // energy = e - // virial = 6-vec vir - // NOTE: add tally function - - if (evflag) { + virpolar[0] -= vxx; + virpolar[1] -= vyy; + virpolar[2] -= vzz; + virpolar[3] -= vxy; + virpolar[4] -= vxz; + virpolar[5] -= vyz; } } } @@ -1191,6 +1188,8 @@ void PairAmoeba::polar_real() torque2force(i,tep,fix,fiy,fiz,f); + if (!vflag_global) continue; + iz = zaxis2local[i]; ix = xaxis2local[i]; iy = yaxis2local[i]; @@ -2163,10 +2162,12 @@ void PairAmoeba::polar_kspace() // increment the total internal virial tensor components - virpolar[0] -= vxx; - virpolar[1] -= vyy; - virpolar[2] -= vzz; - virpolar[3] -= vxy; - virpolar[4] -= vxz; - virpolar[5] -= vyz; + if (vflag_global) { + virpolar[0] -= vxx; + virpolar[1] -= vyy; + virpolar[2] -= vzz; + virpolar[3] -= vxy; + virpolar[4] -= vxz; + virpolar[5] -= vyz; + } } diff --git a/src/AMOEBA/amoeba_repulsion.cpp b/src/AMOEBA/amoeba_repulsion.cpp index c2bd490715..632996c264 100644 --- a/src/AMOEBA/amoeba_repulsion.cpp +++ b/src/AMOEBA/amoeba_repulsion.cpp @@ -354,32 +354,24 @@ void PairAmoeba::repulsion() // increment the virial due to pairwise Cartesian forces - vxx = -xr * frcx; - vxy = -0.5 * (yr*frcx+xr*frcy); - vxz = -0.5 * (zr*frcx+xr*frcz); - vyy = -yr * frcy; - vyz = -0.5 * (zr*frcy+yr*frcz); - vzz = -zr * frcz; + if (vflag_global) { + vxx = -xr * frcx; + vxy = -0.5 * (yr*frcx+xr*frcy); + vxz = -0.5 * (zr*frcx+xr*frcz); + vyy = -yr * frcy; + vyz = -0.5 * (zr*frcy+yr*frcz); + vzz = -zr * frcz; - virrepulse[0] -= vxx; - virrepulse[1] -= vyy; - virrepulse[2] -= vzz; - virrepulse[3] -= vxy; - virrepulse[4] -= vxz; - virrepulse[5] -= vyz; - - // energy = e - // virial = 6-vec vir - // NOTE: add tally function - - if (evflag) { + virrepulse[0] -= vxx; + virrepulse[1] -= vyy; + virrepulse[2] -= vzz; + virrepulse[3] -= vxy; + virrepulse[4] -= vxz; + virrepulse[5] -= vyz; } } } - // DEBUG - //fclose(fp); - // reverse comm to sum torque from ghost atoms to owned atoms crstyle = TORQUE; @@ -390,6 +382,8 @@ void PairAmoeba::repulsion() for (i = 0; i < nlocal; i++) { torque2force(i,tq[i],fix,fiy,fiz,f); + if (!vflag_global) continue; + iz = zaxis2local[i]; ix = xaxis2local[i]; iy = yaxis2local[i]; @@ -420,12 +414,6 @@ void PairAmoeba::repulsion() virrepulse[3] -= vxy; virrepulse[4] -= vxz; virrepulse[5] -= vyz; - - // virial = 6-vec vir - // NOTE: add tally function - - if (evflag) { - } } } diff --git a/src/AMOEBA/pair_amoeba.cpp b/src/AMOEBA/pair_amoeba.cpp index 21feb94af8..74013fd5e0 100644 --- a/src/AMOEBA/pair_amoeba.cpp +++ b/src/AMOEBA/pair_amoeba.cpp @@ -49,8 +49,6 @@ enum{GEAR,ASPC,LSQR}; #define DELTASTACK 16 -#define UIND_DEBUG 0 // also in amoeba_induce.cpp - /* ---------------------------------------------------------------------- */ PairAmoeba::PairAmoeba(LAMMPS *lmp) : Pair(lmp) @@ -67,10 +65,16 @@ PairAmoeba::PairAmoeba(LAMMPS *lmp) : Pair(lmp) me = comm->me; nprocs = comm->nprocs; - // force field settings + // pair style settings one_coeff = 1; single_enable = 0; + no_virial_fdotr_compute = 1; + + nextra = 6; + pvector = new double[nextra]; + + // force field settings amoeba = 1; hippo = 0; @@ -165,6 +169,8 @@ PairAmoeba::PairAmoeba(LAMMPS *lmp) : Pair(lmp) PairAmoeba::~PairAmoeba() { + delete [] pvector; + // check nfix in case all fixes have already been deleted if (modify->nfix) { @@ -275,26 +281,12 @@ PairAmoeba::~PairAmoeba() } delete [] factors; - - // DEBUG - - if (me == 0 && UIND_DEBUG) fclose(fp_uind); } /* ---------------------------------------------------------------------- */ void PairAmoeba::compute(int eflag, int vflag) { - // DEBUG timer init - - if (update->ntimestep <= 1) { - time_init = time_hal = time_repulse = time_disp = time_mpole = 0.0; - time_induce = time_polar = time_qxfer = 0.0; - } - - double evdwl; - - evdwl = 0.0; ev_init(eflag,vflag); // zero energy/virial components @@ -358,6 +350,13 @@ void PairAmoeba::compute(int eflag, int vflag) // end of one-time initializations // ------------------------------------------------------------------- + // initialize timers on first compute() call after setup + + if (update->ntimestep <= update->beginstep+1) { + time_init = time_hal = time_repulse = time_disp = time_mpole = 0.0; + time_induce = time_polar = time_qxfer = 0.0; + } + double time0,time1,time2,time3,time4,time5,time6,time7,time8; MPI_Barrier(world); @@ -462,29 +461,27 @@ void PairAmoeba::compute(int eflag, int vflag) // charge transfer, pairwise if (hippo && qxfer_flag) charge_transfer(); - time8 = MPI_Wtime(); - // energy, force, virial summations + // store energy components for output by compute pair command - eng_vdwl = ehal + erepulse + edisp + empole + epolar + eqxfer; + pvector[0] = ehal; + pvector[2] = erepulse; + pvector[3] = edisp; + pvector[4] = empole; + pvector[5] = epolar; + pvector[6] = eqxfer; - double **f = atom->f; - nlocal = atom->nlocal; - int nall = nlocal + atom->nghost; + // energy & virial summations + + eng_vdwl = ehal + edisp; + eng_coul = erepulse + empole + epolar + eqxfer; for (int i = 0; i < 6; i++) virial[i] = virhal[i] + virrepulse[i] + virdisp[i] + virpolar[i] + virmpole[i] + virqxfer[i]; - // virial computation - // NOTE: how does this work for AMOEBA ? - // do all terms get summed this way, or only pairwise - // it is 2x what summed virial[6] above is - - // if (vflag_fdotr) virial_fdotr_compute(); - - // timing information + // accumulate timing information time_init += time1 - time0; time_hal += time2 - time1; @@ -494,15 +491,18 @@ void PairAmoeba::compute(int eflag, int vflag) time_induce += time6 - time5; time_polar += time7 - time6; time_qxfer += time8 - time7; +} - // timing output - - if (update->ntimestep < update->laststep) return; +/* ---------------------------------------------------------------------- + print out AMOEBA/HIPPO timing info at end of run +------------------------------------------------------------------------- */ +void PairAmoeba::finish() +{ double ave; MPI_Allreduce(&time_init,&ave,1,MPI_DOUBLE,MPI_SUM,world); time_init = ave/nprocs; - + MPI_Allreduce(&time_hal,&ave,1,MPI_DOUBLE,MPI_SUM,world); time_hal = ave/nprocs; @@ -524,32 +524,32 @@ void PairAmoeba::compute(int eflag, int vflag) MPI_Allreduce(&time_qxfer,&ave,1,MPI_DOUBLE,MPI_SUM,world); time_qxfer = ave/nprocs; - double time_amtot = time_init + time_hal + time_repulse + time_disp + + double time_total = time_init + time_hal + time_repulse + time_disp + time_mpole + time_induce + time_polar + time_qxfer; if (me == 0) { - utils::logmesg(lmp,"\nAMEOBA/HIPPO timing info:\n"); - utils::logmesg(lmp," Init time: {:.6g} {:.6g}\n", - time_init,time_init/time_amtot); + utils::logmesg(lmp,"\nAMEOBA/HIPPO timing breakdown:\n"); + utils::logmesg(lmp," Init time: {:.6g} {:.6g}\n", + time_init,time_init/time_total); if (amoeba) - utils::logmesg(lmp," Hal time: {:.6g} {:.6g}\n", - time_hal,time_hal/time_amtot*100); + utils::logmesg(lmp," Hal time: {:.6g} {:.6g}\n", + time_hal,time_hal/time_total*100); if (hippo) - utils::logmesg(lmp," Repls time: {:.6g} {:.6g}\n", - time_repulse,time_repulse/time_amtot*100); + utils::logmesg(lmp," Repulse time: {:.6g} {:.6g}\n", + time_repulse,time_repulse/time_total*100); if (hippo) - utils::logmesg(lmp," Disp time: {:.6g} {:.6g}\n", - time_disp,time_disp/time_amtot*100); - utils::logmesg(lmp," Mpole time: {:.6g} {:.6g}\n", - time_mpole,time_mpole/time_amtot*100); - utils::logmesg(lmp," Induce time: {:.6g} {:.6g}\n", - time_induce,time_induce/time_amtot*100); - utils::logmesg(lmp," Polar time: {:.6g} {:.6g}\n", - time_polar,time_polar/time_amtot*100); + utils::logmesg(lmp," Disp time: {:.6g} {:.6g}\n", + time_disp,time_disp/time_total*100); + utils::logmesg(lmp," Mpole time: {:.6g} {:.6g}\n", + time_mpole,time_mpole/time_total*100); + utils::logmesg(lmp," Induce time: {:.6g} {:.6g}\n", + time_induce,time_induce/time_total*100); + utils::logmesg(lmp," Polar time: {:.6g} {:.6g}\n", + time_polar,time_polar/time_total*100); if (hippo) - utils::logmesg(lmp," Qxfer time: {:.6g} {:.6g}\n", - time_qxfer,time_qxfer/time_amtot*100); - utils::logmesg(lmp," Total time: {:.6g}\n\n",time_amtot); + utils::logmesg(lmp," Qxfer time: {:.6g} {:.6g}\n", + time_qxfer,time_qxfer/time_total*100); + utils::logmesg(lmp," Total time: {:.6g}\n",time_total); } } @@ -1016,15 +1016,6 @@ void PairAmoeba::init_style() // request neighbor lists int irequest = neighbor->request(this,instance_me); - - // open debug output files - // names are hard-coded - - if (me == 0) { - char fname[32]; - sprintf(fname,"tmp.uind.kspace.%d",nprocs); - if (UIND_DEBUG) fp_uind = fopen(fname,"w"); - } } /* ---------------------------------------------------------------------- diff --git a/src/AMOEBA/pair_amoeba.h b/src/AMOEBA/pair_amoeba.h index f557f81772..21811d2610 100644 --- a/src/AMOEBA/pair_amoeba.h +++ b/src/AMOEBA/pair_amoeba.h @@ -46,6 +46,7 @@ class PairAmoeba : public Pair { void coeff(int, char **); void init_style(); double init_one(int, int); + void finish(); int pack_forward_comm(int, int *, double *, int, int *); void unpack_forward_comm(int, int, double *); diff --git a/src/finish.cpp b/src/finish.cpp index ea472682a2..b74bcf3a0e 100644 --- a/src/finish.cpp +++ b/src/finish.cpp @@ -28,6 +28,7 @@ #include "neigh_request.h" #include "neighbor.h" // IWYU pragma: keep #include "output.h" +#include "pair.h" #include "thermo.h" #include "timer.h" // IWYU pragma: keep #include "universe.h" @@ -214,6 +215,10 @@ void Finish::end(int flag) } } + // pair_style timing stats if provided + + if (force->pair) force->pair->finish(); + // PRD stats if (prdflag) { diff --git a/src/pair.h b/src/pair.h index 8c1c8340eb..cb36009af1 100644 --- a/src/pair.h +++ b/src/pair.h @@ -169,6 +169,7 @@ class Pair : protected Pointers { return 0.0; } + virtual void finish() {} virtual void settings(int, char **) = 0; virtual void coeff(int, char **) = 0; diff --git a/src/pair_hybrid.cpp b/src/pair_hybrid.cpp index 82dce4d5f2..5977a8b101 100644 --- a/src/pair_hybrid.cpp +++ b/src/pair_hybrid.cpp @@ -192,6 +192,12 @@ void PairHybrid::compute(int eflag, int vflag) if (vflag_fdotr) virial_fdotr_compute(); } +/* ---------------------------------------------------------------------- */ + +void PairHybrid::finish() +{ + for (int m = 0; m < nstyles; m++) styles[m]->finish(); +} /* ---------------------------------------------------------------------- */ diff --git a/src/pair_hybrid.h b/src/pair_hybrid.h index ee56783700..358e8d28d0 100644 --- a/src/pair_hybrid.h +++ b/src/pair_hybrid.h @@ -46,6 +46,7 @@ class PairHybrid : public Pair { void init_style() override; double init_one(int, int) override; void setup() override; + void finish(); void write_restart(FILE *) override; void read_restart(FILE *) override; double single(int, int, int, int, double, double, double, double &) override; From 2b51a92231c3c2e339e77786821bf977aa9bc431 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Wed, 18 May 2022 10:13:56 -0600 Subject: [PATCH 165/585] error check for per-atom eng/virial request --- src/AMOEBA/pair_amoeba.cpp | 4 ++++ 1 file changed, 4 insertions(+) diff --git a/src/AMOEBA/pair_amoeba.cpp b/src/AMOEBA/pair_amoeba.cpp index 74013fd5e0..d59c0570af 100644 --- a/src/AMOEBA/pair_amoeba.cpp +++ b/src/AMOEBA/pair_amoeba.cpp @@ -289,6 +289,10 @@ void PairAmoeba::compute(int eflag, int vflag) { ev_init(eflag,vflag); + if (eflag_atom || vflag_atom) + error->all(FLERR,"Cannot (yet) compute per-atom energy/virial " + "with pair_style amoeba/hippo"); + // zero energy/virial components ehal = erepulse = edisp = epolar = empole = eqxfer = 0.0; From 15eebd43b9a568262b14cfc7bd8060eabb65098c Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Wed, 18 May 2022 15:47:43 -0600 Subject: [PATCH 166/585] address some NOTE comments --- src/AMOEBA/amoeba_convolution.cpp | 6 ++---- src/AMOEBA/amoeba_convolution.h | 2 +- src/AMOEBA/amoeba_dispersion.cpp | 11 ++++------- src/AMOEBA/amoeba_file.cpp | 2 -- src/AMOEBA/amoeba_induce.cpp | 9 ++------- src/AMOEBA/amoeba_utils.cpp | 3 ++- src/AMOEBA/angle_amoeba.cpp | 9 +++++---- 7 files changed, 16 insertions(+), 26 deletions(-) diff --git a/src/AMOEBA/amoeba_convolution.cpp b/src/AMOEBA/amoeba_convolution.cpp index 4759a047df..bb99f48422 100644 --- a/src/AMOEBA/amoeba_convolution.cpp +++ b/src/AMOEBA/amoeba_convolution.cpp @@ -72,9 +72,7 @@ AmoebaConvolution::AmoebaConvolution(LAMMPS *lmp, Pair *pair, flag3d = 1; if (which == POLAR_GRIDC || which == INDUCE_GRIDC) flag3d = 0; - // NOTE: worry about overflow - - nfft_global = nx * ny * nz; + nfft_global = (bingint) nx * ny * nz; // global indices of grid range from 0 to N-1 // nlo_in,nhi_in = lower/upper limits of the 3d sub-brick of @@ -111,7 +109,7 @@ AmoebaConvolution::AmoebaConvolution(LAMMPS *lmp, Pair *pair, // dist[3] = particle position bound = subbox + skin/2.0 // convert to triclinic if necessary // nlo_out,nhi_out = nlo,nhi + stencil size for particle mapping - // NOTE: this needs to be computed same as IGRID in amoeba + // NOTE: this needs to be computed same as IGRID in PairAmoeba double *prd,*boxlo,*sublo,*subhi; int triclinic = domain->triclinic; diff --git a/src/AMOEBA/amoeba_convolution.h b/src/AMOEBA/amoeba_convolution.h index d15fe8d198..270a501a71 100644 --- a/src/AMOEBA/amoeba_convolution.h +++ b/src/AMOEBA/amoeba_convolution.h @@ -33,11 +33,11 @@ class AmoebaConvolution : protected Pointers { public: int nx,ny,nz; int order; - int nfft_global; // nx * ny * nz int nfft_owned; // owned grid points in FFT decomp int nxlo_in,nxhi_in,nylo_in,nyhi_in,nzlo_in,nzhi_in; int nxlo_out,nxhi_out,nylo_out,nyhi_out,nzlo_out,nzhi_out; int nxlo_fft,nxhi_fft,nylo_fft,nyhi_fft,nzlo_fft,nzhi_fft; + bigint nfft_global; // nx * ny * nz double *grid_brick_start; // lower left corner of (c)grid_brick data AmoebaConvolution(class LAMMPS *, class Pair *, diff --git a/src/AMOEBA/amoeba_dispersion.cpp b/src/AMOEBA/amoeba_dispersion.cpp index 83405cfab9..905a67c92e 100644 --- a/src/AMOEBA/amoeba_dispersion.cpp +++ b/src/AMOEBA/amoeba_dispersion.cpp @@ -245,7 +245,7 @@ void PairAmoeba::dispersion_kspace() int it1,it2,it3; int j0,jgrd0; int k0,kgrd0; - double e,fi,denom; + double e,fi,denom,scale; double r1,r2,r3; double h1,h2,h3; double term,vterm; @@ -317,9 +317,6 @@ void PairAmoeba::dispersion_kspace() fac3 = -2.0*aewald*MY_PI*MY_PI; denom0 = (6.0*volbox)/pow(MY_PI,1.5); - //qgrid[0][0][0][0] = 0.0; // NOTE: why is this needed? - //qgrid[0][0][0][1] = 0.0; - n = 0; for (k = nzlo; k <= nzhi; k++) { for (j = nylo; j <= nyhi; j++) { @@ -355,9 +352,9 @@ void PairAmoeba::dispersion_kspace() virdisp[5] -= h2*h3*vterm; } } else term1 = 0.0; - // NOTE: pre-calc this division only once - gridfft[n] *= -(term1/denom); - gridfft[n+1] *= -(term1/denom); + scale = -term1 / denom; + gridfft[n] *= scale; + gridfft[n+1] *= scale; n += 2; } } diff --git a/src/AMOEBA/amoeba_file.cpp b/src/AMOEBA/amoeba_file.cpp index 34fe2f87a9..431edfd557 100644 --- a/src/AMOEBA/amoeba_file.cpp +++ b/src/AMOEBA/amoeba_file.cpp @@ -107,8 +107,6 @@ void PairAmoeba::read_prmfile(char *filename) if (n < 0) break; MPI_Bcast(line,n+1,MPI_CHAR,0,world); - //printf("Section: %s\n",line); - if (strstr(line,"Force Field") == line) section = FFIELD; else if (strstr(line,"Literature") == line) section = LITERATURE; else if (strstr(line,"Atom Type") == line) section = ATOMTYPE; diff --git a/src/AMOEBA/amoeba_induce.cpp b/src/AMOEBA/amoeba_induce.cpp index a4b7b2e1c6..1d911177ee 100644 --- a/src/AMOEBA/amoeba_induce.cpp +++ b/src/AMOEBA/amoeba_induce.cpp @@ -102,8 +102,8 @@ void PairAmoeba::induce() } // get induced dipoles via the OPT extrapolation method - // NOTE: any way to rewrite these loops to avoid allocating - // uopt,uoptp with a optorder+1 dimension, just optorder ?? + // NOTE: could rewrite these loops to avoid allocating + // uopt,uoptp with a optorder+1 dimension, just optorder // since no need to store optorder+1 values after these loops if (poltyp == OPT) { @@ -332,8 +332,6 @@ void PairAmoeba::induce() } } - // NOTE: comp of b,bp and allreduce only needed if pcgprec ? - reduce[0] = b; reduce[1] = bp; MPI_Allreduce(reduce,allreduce,4,MPI_DOUBLE,MPI_SUM,world); @@ -458,7 +456,6 @@ void PairAmoeba::ulspred() } // derive normal equations corresponding to least squares fit - // NOTE: check all N vs N-1 indices in code from here down } else if (polpred == LSQR) { double ***udalt = fixudalt->tstore; @@ -1201,8 +1198,6 @@ void PairAmoeba::udirect2b(double **field, double **fieldp) numneigh = list->numneigh; firstneigh = list->firstneigh; - // NOTE: does this have a problem if aewald is tiny ?? - aesq2 = 2.0 * aewald * aewald; aesq2n = 0.0; if (aewald > 0.0) aesq2n = 1.0 / (MY_PIS*aewald); diff --git a/src/AMOEBA/amoeba_utils.cpp b/src/AMOEBA/amoeba_utils.cpp index 059587a093..7bb95a26a2 100644 --- a/src/AMOEBA/amoeba_utils.cpp +++ b/src/AMOEBA/amoeba_utils.cpp @@ -34,7 +34,6 @@ enum{NOFRAME,ZONLY,ZTHENX,BISECTOR,ZBISECT,THREEFOLD}; any of the values can be 0 if not used yaxis can later be negative due to chkpole() also sets polaxe and pole[13] multipole for each owned atom - NOTE: may not always do this identically to Tinker b/c atom order matters ------------------------------------------------------------------------- */ void PairAmoeba::kmpole() @@ -71,6 +70,8 @@ void PairAmoeba::kmpole() flag = 0; // create a sorted version of bond/angle neighs from special[][] + // NOTE: this is try and do it identically to Tinker + // b/c I think in Tinker, atom order matters as to which case is seen fist for (j = 0; j < nspecial[i][0]; j++) bondneigh[j] = special[i][j]; diff --git a/src/AMOEBA/angle_amoeba.cpp b/src/AMOEBA/angle_amoeba.cpp index e6f866f63b..c81e22c8f3 100644 --- a/src/AMOEBA/angle_amoeba.cpp +++ b/src/AMOEBA/angle_amoeba.cpp @@ -315,7 +315,7 @@ void AngleAmoeba::tinker_anglep(int i1, int i2, int i3, int type, int eflag) rap2 = xap*xap + yap*yap + zap*zap; rcp2 = xcp*xcp + ycp*ycp + zcp*zcp; - // NOTE: can these be 0.0 ? what to do? + // Tinker just skips the computation in either is zero if (rap2 == 0.0 || rcp2 == 0.0) return; @@ -825,7 +825,10 @@ void AngleAmoeba::write_data(FILE *fp) fprintf(fp,"%d %g %g\n",i,ub_k[i],ub_r0[i]); } -/* ---------------------------------------------------------------------- */ +/* ---------------------------------------------------------------------- + only computes tinker_angle() and tinker_bondangle() + does not compute tinker_anglep() and tinker_urey_bradley() +---------------------------------------------------------------------- */ double AngleAmoeba::single(int type, int i1, int i2, int i3) { @@ -866,7 +869,5 @@ double AngleAmoeba::single(int type, int i1, int i2, int i3) double dr2 = r2 - ba_r2[type]; energy += ba_k1[type]*dr1*dtheta + ba_k2[type]*dr2*dtheta; - // NOTE: add UB term - return energy; } From 06ad1198448cab2a3d17f73306dac22226684339 Mon Sep 17 00:00:00 2001 From: Stan Gerald Moore Date: Wed, 18 May 2022 17:15:36 -0600 Subject: [PATCH 167/585] Initial refactor of view allocation in Kokkos package --- src/KOKKOS/memory_kokkos.h | 22 ++- src/KOKKOS/pair_pace_kokkos.cpp | 206 ++++++++++++++--------------- src/KOKKOS/pair_reaxff_kokkos.cpp | 161 +++++++--------------- src/KOKKOS/pair_reaxff_kokkos.h | 1 - src/KOKKOS/pair_snap_kokkos.h | 33 +---- src/KOKKOS/pair_snap_kokkos_impl.h | 34 ++--- src/KOKKOS/sna_kokkos_impl.h | 201 ++++++++++++++-------------- 7 files changed, 283 insertions(+), 375 deletions(-) diff --git a/src/KOKKOS/memory_kokkos.h b/src/KOKKOS/memory_kokkos.h index e82746f34d..092e20b6c7 100644 --- a/src/KOKKOS/memory_kokkos.h +++ b/src/KOKKOS/memory_kokkos.h @@ -20,6 +20,8 @@ namespace LAMMPS_NS { +typedef MemoryKokkos MemKK; + class MemoryKokkos : public Memory { public: MemoryKokkos(class LAMMPS *lmp) : Memory(lmp) {} @@ -279,44 +281,50 @@ void destroy_kokkos(TYPE data, typename TYPE::value_type** &array) ------------------------------------------------------------------------- */ template -void realloc_kokkos(TYPE &data, const char *name, int n1) +static void realloc_kokkos(TYPE &data, const char *name, int n1) { data = TYPE(); + assert(data.use_count() == 0); data = TYPE(Kokkos::NoInit(std::string(name)),n1); } template -void realloc_kokkos(TYPE &data, const char *name, int n1, int n2) +static void realloc_kokkos(TYPE &data, const char *name, int n1, int n2) { data = TYPE(); + assert(data.use_count() == 0); data = TYPE(Kokkos::NoInit(std::string(name)),n1,n2); } template -void realloc_kokkos(TYPE &data, const char *name, int n1, int n2, int n3) +static void realloc_kokkos(TYPE &data, const char *name, int n1, int n2, int n3) { data = TYPE(); + assert(data.use_count() == 0); data = TYPE(Kokkos::NoInit(std::string(name)),n1,n2,n3); } template -void realloc_kokkos(TYPE &data, const char *name, int n1, int n2, int n3, int n4) +static void realloc_kokkos(TYPE &data, const char *name, int n1, int n2, int n3, int n4) { data = TYPE(); + assert(data.use_count() == 0); data = TYPE(Kokkos::NoInit(std::string(name)),n1,n2,n3,n4); } template -void realloc_kokkos(TYPE &data, const char *name, int n1, int n2, int n3, int n4, int n5) +static void realloc_kokkos(TYPE &data, const char *name, int n1, int n2, int n3, int n4, int n5) { data = TYPE(); + assert(data.use_count() == 0); data = TYPE(Kokkos::NoInit(std::string(name)),n1,n2,n3,n4,n5); } template -void realloc_kokkos(TYPE &data, const char *name, int n1, int n2, int n3, int n4, int n5, int n6) +static void realloc_kokkos(TYPE &data, const char *name, int n1, int n2, int n3, int n4, int n5, int n6) { data = TYPE(); + assert(data.use_count() == 0); data = TYPE(Kokkos::NoInit(std::string(name)),n1,n2,n3,n4,n5,n6); } @@ -325,7 +333,7 @@ void realloc_kokkos(TYPE &data, const char *name, int n1, int n2, int n3, int n4 ------------------------------------------------------------------------- */ template -double memory_usage(TYPE &data) +static double memory_usage(TYPE &data) { return data.span() * sizeof(typename TYPE::value_type); } diff --git a/src/KOKKOS/pair_pace_kokkos.cpp b/src/KOKKOS/pair_pace_kokkos.cpp index ddf3bf9107..9d78b63167 100644 --- a/src/KOKKOS/pair_pace_kokkos.cpp +++ b/src/KOKKOS/pair_pace_kokkos.cpp @@ -104,55 +104,55 @@ void PairPACEKokkos::grow(int natom, int maxneigh) if ((int)A.extent(0) < natom) { - memoryKK->realloc_kokkos(A, "pace:A", natom, nelements, nradmax + 1, (lmax + 1) * (lmax + 1)); - memoryKK->realloc_kokkos(A_rank1, "pace:A_rank1", natom, nelements, nradbase); + MemKK::realloc_kokkos(A, "pace:A", natom, nelements, nradmax + 1, (lmax + 1) * (lmax + 1)); + MemKK::realloc_kokkos(A_rank1, "pace:A_rank1", natom, nelements, nradbase); - memoryKK->realloc_kokkos(A_list, "pace:A_list", natom, idx_rho_max, basis_set->rankmax); + MemKK::realloc_kokkos(A_list, "pace:A_list", natom, idx_rho_max, basis_set->rankmax); //size is +1 of max to avoid out-of-boundary array access in double-triangular scheme - memoryKK->realloc_kokkos(A_forward_prod, "pace:A_forward_prod", natom, idx_rho_max, basis_set->rankmax + 1); + MemKK::realloc_kokkos(A_forward_prod, "pace:A_forward_prod", natom, idx_rho_max, basis_set->rankmax + 1); - memoryKK->realloc_kokkos(e_atom, "pace:e_atom", natom); - memoryKK->realloc_kokkos(rhos, "pace:rhos", natom, basis_set->ndensitymax + 1); // +1 density for core repulsion - memoryKK->realloc_kokkos(dF_drho, "pace:dF_drho", natom, basis_set->ndensitymax + 1); // +1 density for core repulsion + MemKK::realloc_kokkos(e_atom, "pace:e_atom", natom); + MemKK::realloc_kokkos(rhos, "pace:rhos", natom, basis_set->ndensitymax + 1); // +1 density for core repulsion + MemKK::realloc_kokkos(dF_drho, "pace:dF_drho", natom, basis_set->ndensitymax + 1); // +1 density for core repulsion - memoryKK->realloc_kokkos(weights, "pace:weights", natom, nelements, nradmax + 1, (lmax + 1) * (lmax + 1)); - memoryKK->realloc_kokkos(weights_rank1, "pace:weights_rank1", natom, nelements, nradbase); + MemKK::realloc_kokkos(weights, "pace:weights", natom, nelements, nradmax + 1, (lmax + 1) * (lmax + 1)); + MemKK::realloc_kokkos(weights_rank1, "pace:weights_rank1", natom, nelements, nradbase); // hard-core repulsion - memoryKK->realloc_kokkos(rho_core, "pace:rho_core", natom); - memoryKK->realloc_kokkos(dF_drho_core, "pace:dF_drho_core", natom); - memoryKK->realloc_kokkos(dB_flatten, "pace:dB_flatten", natom, idx_rho_max, basis_set->rankmax); + MemKK::realloc_kokkos(rho_core, "pace:rho_core", natom); + MemKK::realloc_kokkos(dF_drho_core, "pace:dF_drho_core", natom); + MemKK::realloc_kokkos(dB_flatten, "pace:dB_flatten", natom, idx_rho_max, basis_set->rankmax); } if (((int)ylm.extent(0) < natom) || ((int)ylm.extent(1) < maxneigh)) { // radial functions - memoryKK->realloc_kokkos(fr, "pace:fr", natom, maxneigh, nradmax, lmax + 1); - memoryKK->realloc_kokkos(dfr, "pace:dfr", natom, maxneigh, nradmax, lmax + 1); - memoryKK->realloc_kokkos(gr, "pace:gr", natom, maxneigh, nradbase); - memoryKK->realloc_kokkos(dgr, "pace:dgr", natom, maxneigh, nradbase); + MemKK::realloc_kokkos(fr, "pace:fr", natom, maxneigh, nradmax, lmax + 1); + MemKK::realloc_kokkos(dfr, "pace:dfr", natom, maxneigh, nradmax, lmax + 1); + MemKK::realloc_kokkos(gr, "pace:gr", natom, maxneigh, nradbase); + MemKK::realloc_kokkos(dgr, "pace:dgr", natom, maxneigh, nradbase); const int max_num_functions = MAX(nradbase, nradmax*(lmax + 1)); - memoryKK->realloc_kokkos(d_values, "pace:d_values", natom, maxneigh, max_num_functions); - memoryKK->realloc_kokkos(d_derivatives, "pace:d_derivatives", natom, maxneigh, max_num_functions); + MemKK::realloc_kokkos(d_values, "pace:d_values", natom, maxneigh, max_num_functions); + MemKK::realloc_kokkos(d_derivatives, "pace:d_derivatives", natom, maxneigh, max_num_functions); // hard-core repulsion - memoryKK->realloc_kokkos(cr, "pace:cr", natom, maxneigh); - memoryKK->realloc_kokkos(dcr, "pace:dcr", natom, maxneigh); + MemKK::realloc_kokkos(cr, "pace:cr", natom, maxneigh); + MemKK::realloc_kokkos(dcr, "pace:dcr", natom, maxneigh); // spherical harmonics - memoryKK->realloc_kokkos(plm, "pace:plm", natom, maxneigh, (lmax + 1) * (lmax + 1)); - memoryKK->realloc_kokkos(dplm, "pace:dplm", natom, maxneigh, (lmax + 1) * (lmax + 1)); - memoryKK->realloc_kokkos(ylm, "pace:ylm", natom, maxneigh, (lmax + 1) * (lmax + 1)); - memoryKK->realloc_kokkos(dylm, "pace:dylm", natom, maxneigh, (lmax + 1) * (lmax + 1)); + MemKK::realloc_kokkos(plm, "pace:plm", natom, maxneigh, (lmax + 1) * (lmax + 1)); + MemKK::realloc_kokkos(dplm, "pace:dplm", natom, maxneigh, (lmax + 1) * (lmax + 1)); + MemKK::realloc_kokkos(ylm, "pace:ylm", natom, maxneigh, (lmax + 1) * (lmax + 1)); + MemKK::realloc_kokkos(dylm, "pace:dylm", natom, maxneigh, (lmax + 1) * (lmax + 1)); // short neigh list - memoryKK->realloc_kokkos(d_ncount, "pace:ncount", natom); - memoryKK->realloc_kokkos(d_mu, "pace:mu", natom, maxneigh); - memoryKK->realloc_kokkos(d_rhats, "pace:rhats", natom, maxneigh); - memoryKK->realloc_kokkos(d_rnorms, "pace:rnorms", natom, maxneigh); - memoryKK->realloc_kokkos(d_nearest, "pace:nearest", natom, maxneigh); + MemKK::realloc_kokkos(d_ncount, "pace:ncount", natom); + MemKK::realloc_kokkos(d_mu, "pace:mu", natom, maxneigh); + MemKK::realloc_kokkos(d_rhats, "pace:rhats", natom, maxneigh); + MemKK::realloc_kokkos(d_rnorms, "pace:rnorms", natom, maxneigh); + MemKK::realloc_kokkos(d_nearest, "pace:nearest", natom, maxneigh); - memoryKK->realloc_kokkos(f_ij, "pace:f_ij", natom, maxneigh); + MemKK::realloc_kokkos(f_ij, "pace:f_ij", natom, maxneigh); } } @@ -163,11 +163,11 @@ void PairPACEKokkos::copy_pertype() { auto basis_set = aceimpl->basis_set; - memoryKK->realloc_kokkos(d_rho_core_cutoff, "pace:rho_core_cutoff", nelements); - memoryKK->realloc_kokkos(d_drho_core_cutoff, "pace:drho_core_cutoff", nelements); - memoryKK->realloc_kokkos(d_E0vals, "pace:E0vals", nelements); - memoryKK->realloc_kokkos(d_ndensity, "pace:ndensity", nelements); - memoryKK->realloc_kokkos(d_npoti, "pace:npoti", nelements); + MemKK::realloc_kokkos(d_rho_core_cutoff, "pace:rho_core_cutoff", nelements); + MemKK::realloc_kokkos(d_drho_core_cutoff, "pace:drho_core_cutoff", nelements); + MemKK::realloc_kokkos(d_E0vals, "pace:E0vals", nelements); + MemKK::realloc_kokkos(d_ndensity, "pace:ndensity", nelements); + MemKK::realloc_kokkos(d_npoti, "pace:npoti", nelements); auto h_rho_core_cutoff = Kokkos::create_mirror_view(d_rho_core_cutoff); auto h_drho_core_cutoff = Kokkos::create_mirror_view(d_drho_core_cutoff); @@ -196,8 +196,8 @@ void PairPACEKokkos::copy_pertype() Kokkos::deep_copy(d_ndensity, h_ndensity); Kokkos::deep_copy(d_npoti, h_npoti); - memoryKK->realloc_kokkos(d_wpre, "pace:wpre", nelements, basis_set->ndensitymax); - memoryKK->realloc_kokkos(d_mexp, "pace:mexp", nelements, basis_set->ndensitymax); + MemKK::realloc_kokkos(d_wpre, "pace:wpre", nelements, basis_set->ndensitymax); + MemKK::realloc_kokkos(d_mexp, "pace:mexp", nelements, basis_set->ndensitymax); auto h_wpre = Kokkos::create_mirror_view(d_wpre); auto h_mexp = Kokkos::create_mirror_view(d_mexp); @@ -266,7 +266,7 @@ void PairPACEKokkos::copy_tilde() idx_rho_max = 0; int total_basis_size_max = 0; - memoryKK->realloc_kokkos(d_idx_rho_count, "pace:idx_rho_count", nelements); + MemKK::realloc_kokkos(d_idx_rho_count, "pace:idx_rho_count", nelements); auto h_idx_rho_count = Kokkos::create_mirror_view(d_idx_rho_count); for (int n = 0; n < nelements; n++) { @@ -295,14 +295,14 @@ void PairPACEKokkos::copy_tilde() Kokkos::deep_copy(d_idx_rho_count, h_idx_rho_count); - memoryKK->realloc_kokkos(d_rank, "pace:rank", nelements, total_basis_size_max); - memoryKK->realloc_kokkos(d_num_ms_combs, "pace:num_ms_combs", nelements, total_basis_size_max); - memoryKK->realloc_kokkos(d_offsets, "pace:offsets", nelements, idx_rho_max); - memoryKK->realloc_kokkos(d_mus, "pace:mus", nelements, total_basis_size_max, basis_set->rankmax); - memoryKK->realloc_kokkos(d_ns, "pace:ns", nelements, total_basis_size_max, basis_set->rankmax); - memoryKK->realloc_kokkos(d_ls, "pace:ls", nelements, total_basis_size_max, basis_set->rankmax); - memoryKK->realloc_kokkos(d_ms_combs, "pace:ms_combs", nelements, idx_rho_max, basis_set->rankmax); - memoryKK->realloc_kokkos(d_ctildes, "pace:ctildes", nelements, idx_rho_max, basis_set->ndensitymax); + MemKK::realloc_kokkos(d_rank, "pace:rank", nelements, total_basis_size_max); + MemKK::realloc_kokkos(d_num_ms_combs, "pace:num_ms_combs", nelements, total_basis_size_max); + MemKK::realloc_kokkos(d_offsets, "pace:offsets", nelements, idx_rho_max); + MemKK::realloc_kokkos(d_mus, "pace:mus", nelements, total_basis_size_max, basis_set->rankmax); + MemKK::realloc_kokkos(d_ns, "pace:ns", nelements, total_basis_size_max, basis_set->rankmax); + MemKK::realloc_kokkos(d_ls, "pace:ls", nelements, total_basis_size_max, basis_set->rankmax); + MemKK::realloc_kokkos(d_ms_combs, "pace:ms_combs", nelements, idx_rho_max, basis_set->rankmax); + MemKK::realloc_kokkos(d_ctildes, "pace:ctildes", nelements, idx_rho_max, basis_set->ndensitymax); auto h_rank = Kokkos::create_mirror_view(d_rank); auto h_num_ms_combs = Kokkos::create_mirror_view(d_num_ms_combs); @@ -418,10 +418,10 @@ void PairPACEKokkos::init_style() // spherical harmonics - memoryKK->realloc_kokkos(alm, "pace:alm", (lmax + 1) * (lmax + 1)); - memoryKK->realloc_kokkos(blm, "pace:blm", (lmax + 1) * (lmax + 1)); - memoryKK->realloc_kokkos(cl, "pace:cl", lmax + 1); - memoryKK->realloc_kokkos(dl, "pace:dl", lmax + 1); + MemKK::realloc_kokkos(alm, "pace:alm", (lmax + 1) * (lmax + 1)); + MemKK::realloc_kokkos(blm, "pace:blm", (lmax + 1) * (lmax + 1)); + MemKK::realloc_kokkos(cl, "pace:cl", lmax + 1); + MemKK::realloc_kokkos(dl, "pace:dl", lmax + 1); pre_compute_harmonics(lmax); copy_pertype(); @@ -474,12 +474,12 @@ void PairPACEKokkos::allocate() PairPACE::allocate(); int n = atom->ntypes + 1; - memoryKK->realloc_kokkos(d_map, "pace:map", n); + MemKK::realloc_kokkos(d_map, "pace:map", n); - memoryKK->realloc_kokkos(k_cutsq, "pace:cutsq", n, n); + MemKK::realloc_kokkos(k_cutsq, "pace:cutsq", n, n); d_cutsq = k_cutsq.template view(); - memoryKK->realloc_kokkos(k_scale, "pace:scale", n, n); + MemKK::realloc_kokkos(k_scale, "pace:scale", n, n); d_scale = k_scale.template view(); } @@ -1651,56 +1651,56 @@ double PairPACEKokkos::memory_usage() { double bytes = 0; - bytes += memoryKK->memory_usage(A); - bytes += memoryKK->memory_usage(A_rank1); - bytes += memoryKK->memory_usage(A_list); - bytes += memoryKK->memory_usage(A_forward_prod); - bytes += memoryKK->memory_usage(e_atom); - bytes += memoryKK->memory_usage(rhos); - bytes += memoryKK->memory_usage(dF_drho); - bytes += memoryKK->memory_usage(weights); - bytes += memoryKK->memory_usage(weights_rank1); - bytes += memoryKK->memory_usage(rho_core); - bytes += memoryKK->memory_usage(dF_drho_core); - bytes += memoryKK->memory_usage(dB_flatten); - bytes += memoryKK->memory_usage(fr); - bytes += memoryKK->memory_usage(dfr); - bytes += memoryKK->memory_usage(gr); - bytes += memoryKK->memory_usage(dgr); - bytes += memoryKK->memory_usage(d_values); - bytes += memoryKK->memory_usage(d_derivatives); - bytes += memoryKK->memory_usage(cr); - bytes += memoryKK->memory_usage(dcr); - bytes += memoryKK->memory_usage(plm); - bytes += memoryKK->memory_usage(dplm); - bytes += memoryKK->memory_usage(ylm); - bytes += memoryKK->memory_usage(dylm); - bytes += memoryKK->memory_usage(d_ncount); - bytes += memoryKK->memory_usage(d_mu); - bytes += memoryKK->memory_usage(d_rhats); - bytes += memoryKK->memory_usage(d_rnorms); - bytes += memoryKK->memory_usage(d_nearest); - bytes += memoryKK->memory_usage(f_ij); - bytes += memoryKK->memory_usage(d_rho_core_cutoff); - bytes += memoryKK->memory_usage(d_drho_core_cutoff); - bytes += memoryKK->memory_usage(d_E0vals); - bytes += memoryKK->memory_usage(d_ndensity); - bytes += memoryKK->memory_usage(d_npoti); - bytes += memoryKK->memory_usage(d_wpre); - bytes += memoryKK->memory_usage(d_mexp); - bytes += memoryKK->memory_usage(d_idx_rho_count); - bytes += memoryKK->memory_usage(d_rank); - bytes += memoryKK->memory_usage(d_num_ms_combs); - bytes += memoryKK->memory_usage(d_offsets); - bytes += memoryKK->memory_usage(d_mus); - bytes += memoryKK->memory_usage(d_ns); - bytes += memoryKK->memory_usage(d_ls); - bytes += memoryKK->memory_usage(d_ms_combs); - bytes += memoryKK->memory_usage(d_ctildes); - bytes += memoryKK->memory_usage(alm); - bytes += memoryKK->memory_usage(blm); - bytes += memoryKK->memory_usage(cl); - bytes += memoryKK->memory_usage(dl); + bytes += MemKK::memory_usage(A); + bytes += MemKK::memory_usage(A_rank1); + bytes += MemKK::memory_usage(A_list); + bytes += MemKK::memory_usage(A_forward_prod); + bytes += MemKK::memory_usage(e_atom); + bytes += MemKK::memory_usage(rhos); + bytes += MemKK::memory_usage(dF_drho); + bytes += MemKK::memory_usage(weights); + bytes += MemKK::memory_usage(weights_rank1); + bytes += MemKK::memory_usage(rho_core); + bytes += MemKK::memory_usage(dF_drho_core); + bytes += MemKK::memory_usage(dB_flatten); + bytes += MemKK::memory_usage(fr); + bytes += MemKK::memory_usage(dfr); + bytes += MemKK::memory_usage(gr); + bytes += MemKK::memory_usage(dgr); + bytes += MemKK::memory_usage(d_values); + bytes += MemKK::memory_usage(d_derivatives); + bytes += MemKK::memory_usage(cr); + bytes += MemKK::memory_usage(dcr); + bytes += MemKK::memory_usage(plm); + bytes += MemKK::memory_usage(dplm); + bytes += MemKK::memory_usage(ylm); + bytes += MemKK::memory_usage(dylm); + bytes += MemKK::memory_usage(d_ncount); + bytes += MemKK::memory_usage(d_mu); + bytes += MemKK::memory_usage(d_rhats); + bytes += MemKK::memory_usage(d_rnorms); + bytes += MemKK::memory_usage(d_nearest); + bytes += MemKK::memory_usage(f_ij); + bytes += MemKK::memory_usage(d_rho_core_cutoff); + bytes += MemKK::memory_usage(d_drho_core_cutoff); + bytes += MemKK::memory_usage(d_E0vals); + bytes += MemKK::memory_usage(d_ndensity); + bytes += MemKK::memory_usage(d_npoti); + bytes += MemKK::memory_usage(d_wpre); + bytes += MemKK::memory_usage(d_mexp); + bytes += MemKK::memory_usage(d_idx_rho_count); + bytes += MemKK::memory_usage(d_rank); + bytes += MemKK::memory_usage(d_num_ms_combs); + bytes += MemKK::memory_usage(d_offsets); + bytes += MemKK::memory_usage(d_mus); + bytes += MemKK::memory_usage(d_ns); + bytes += MemKK::memory_usage(d_ls); + bytes += MemKK::memory_usage(d_ms_combs); + bytes += MemKK::memory_usage(d_ctildes); + bytes += MemKK::memory_usage(alm); + bytes += MemKK::memory_usage(blm); + bytes += MemKK::memory_usage(cl); + bytes += MemKK::memory_usage(dl); if (k_splines_gk.h_view.data()) { for (int i = 0; i < nelements; i++) { diff --git a/src/KOKKOS/pair_reaxff_kokkos.cpp b/src/KOKKOS/pair_reaxff_kokkos.cpp index 192300d642..7f905c069f 100644 --- a/src/KOKKOS/pair_reaxff_kokkos.cpp +++ b/src/KOKKOS/pair_reaxff_kokkos.cpp @@ -36,6 +36,7 @@ #include "kokkos.h" #include "math_const.h" #include "math_special.h" +#include "memory_kokkos.h" #include "neigh_request.h" #include "neighbor.h" @@ -78,8 +79,8 @@ PairReaxFFKokkos::PairReaxFFKokkos(LAMMPS *lmp) : PairReaxFF(lmp) k_error_flag = DAT::tdual_int_scalar("pair:error_flag"); k_nbuf_local = DAT::tdual_int_scalar("pair:nbuf_local"); - d_torsion_pack = t_reax_int4_2d("reaxff:torsion_pack",1,2); - d_angular_pack = t_reax_int4_2d("reaxff:angular_pack",1,2); + MemKK::realloc_kokkos(d_torsion_pack,"reaxff:torsion_pack",1,2); + MemKK::realloc_kokkos(d_angular_pack,"reaxff:angular_pack",1,2); k_count_angular_torsion = DAT::tdual_int_1d("PairReaxFF::count_angular_torsion",2); d_count_angular_torsion = k_count_angular_torsion.template view(); @@ -959,9 +960,9 @@ void PairReaxFFKokkos::compute(int eflag_in, int vflag_in) count_torsion = h_count_angular_torsion(1); if (count_angular > (int)d_angular_pack.extent(0)) - d_angular_pack = t_reax_int4_2d("reaxff:angular_pack",(int)(count_angular * 1.1),2); + MemKK::realloc_kokkos(d_angular_pack,"reaxff:angular_pack",(int)(count_angular * 1.1),2); if (count_torsion > (int)d_torsion_pack.extent(0)) - d_torsion_pack = t_reax_int4_2d("reaxff:torsion_pack",(int)(count_torsion * 1.1),2); + MemKK::realloc_kokkos(d_torsion_pack,"reaxff:torsion_pack",(int)(count_torsion * 1.1),2); // need to zero to re-count h_count_angular_torsion(0) = 0; @@ -1512,131 +1513,63 @@ void PairReaxFFKokkos::operator()(TagPairReaxComputeTabulatedLJCoulo template void PairReaxFFKokkos::allocate_array() { - // deallocate first to reduce memory overhead - - deallocate_array(); - if (cut_hbsq > 0.0) { - d_hb_first = typename AT::t_int_1d("reaxff/kk:hb_first",nmax); - d_hb_num = typename AT::t_int_1d("reaxff/kk:hb_num",nmax); - d_hb_list = typename AT::t_int_1d("reaxff/kk:hb_list",nmax*maxhb); + MemKK::realloc_kokkos(d_hb_first,"reaxff/kk:hb_first",nmax); + MemKK::realloc_kokkos(d_hb_num,"reaxff/kk:hb_num",nmax); + MemKK::realloc_kokkos(d_hb_list,"reaxff/kk:hb_list",nmax*maxhb); } - d_bo_first = typename AT::t_int_1d("reaxff/kk:bo_first",nmax); - d_bo_num = typename AT::t_int_1d("reaxff/kk:bo_num",nmax); - d_bo_list = typename AT::t_int_1d("reaxff/kk:bo_list",nmax*maxbo); + MemKK::realloc_kokkos(d_bo_first,"reaxff/kk:bo_first",nmax); + MemKK::realloc_kokkos(d_bo_num,"reaxff/kk:bo_num",nmax); + MemKK::realloc_kokkos(d_bo_list,"reaxff/kk:bo_list",nmax*maxbo); - d_BO = typename AT::t_ffloat_2d_dl("reaxff/kk:BO",nmax,maxbo); - d_BO_s = typename AT::t_ffloat_2d_dl("reaxff/kk:BO",nmax,maxbo); - d_BO_pi = typename AT::t_ffloat_2d_dl("reaxff/kk:BO_pi",nmax,maxbo); - d_BO_pi2 = typename AT::t_ffloat_2d_dl("reaxff/kk:BO_pi2",nmax,maxbo); + MemKK::realloc_kokkos(d_BO,"reaxff/kk:BO",nmax,maxbo); + MemKK::realloc_kokkos(d_BO_s,"reaxff/kk:BO",nmax,maxbo); + MemKK::realloc_kokkos(d_BO_pi,"reaxff/kk:BO_pi",nmax,maxbo); + MemKK::realloc_kokkos(d_BO_pi2,"reaxff/kk:BO_pi2",nmax,maxbo); - d_dln_BOp_pi = typename AT::t_ffloat_2d_dl("reaxff/kk:d_dln_BOp_pi",nmax,maxbo); - d_dln_BOp_pi2 = typename AT::t_ffloat_2d_dl("reaxff/kk:d_dln_BOp_pi2",nmax,maxbo); + MemKK::realloc_kokkos(d_dln_BOp_pi,"reaxff/kk:d_dln_BOp_pi",nmax,maxbo); + MemKK::realloc_kokkos(d_dln_BOp_pi2,"reaxff/kk:d_dln_BOp_pi2",nmax,maxbo); - d_C1dbo = typename AT::t_ffloat_2d_dl("reaxff/kk:d_C1dbo",nmax,maxbo); - d_C2dbo = typename AT::t_ffloat_2d_dl("reaxff/kk:d_C2dbo",nmax,maxbo); - d_C3dbo = typename AT::t_ffloat_2d_dl("reaxff/kk:d_C3dbo",nmax,maxbo); + MemKK::realloc_kokkos(d_C1dbo,"reaxff/kk:d_C1dbo",nmax,maxbo); + MemKK::realloc_kokkos(d_C2dbo,"reaxff/kk:d_C2dbo",nmax,maxbo); + MemKK::realloc_kokkos(d_C3dbo,"reaxff/kk:d_C3dbo",nmax,maxbo); - d_C1dbopi = typename AT::t_ffloat_2d_dl("reaxff/kk:d_C1dbopi",nmax,maxbo); - d_C2dbopi = typename AT::t_ffloat_2d_dl("reaxff/kk:d_C2dbopi",nmax,maxbo); - d_C3dbopi = typename AT::t_ffloat_2d_dl("reaxff/kk:d_C3dbopi",nmax,maxbo); - d_C4dbopi = typename AT::t_ffloat_2d_dl("reaxff/kk:d_C4dbopi",nmax,maxbo); + MemKK::realloc_kokkos(d_C1dbopi,"reaxff/kk:d_C1dbopi",nmax,maxbo); + MemKK::realloc_kokkos(d_C2dbopi,"reaxff/kk:d_C2dbopi",nmax,maxbo); + MemKK::realloc_kokkos(d_C3dbopi,"reaxff/kk:d_C3dbopi",nmax,maxbo); + MemKK::realloc_kokkos(d_C4dbopi,"reaxff/kk:d_C4dbopi",nmax,maxbo); - d_C1dbopi2 = typename AT::t_ffloat_2d_dl("reaxff/kk:d_C1dbopi2",nmax,maxbo); - d_C2dbopi2 = typename AT::t_ffloat_2d_dl("reaxff/kk:d_C2dbopi2",nmax,maxbo); - d_C3dbopi2 = typename AT::t_ffloat_2d_dl("reaxff/kk:d_C3dbopi2",nmax,maxbo); - d_C4dbopi2 = typename AT::t_ffloat_2d_dl("reaxff/kk:d_C4dbopi2",nmax,maxbo); + MemKK::realloc_kokkos(d_C1dbopi2,"reaxff/kk:d_C1dbopi2",nmax,maxbo); + MemKK::realloc_kokkos(d_C2dbopi2,"reaxff/kk:d_C2dbopi2",nmax,maxbo); + MemKK::realloc_kokkos(d_C3dbopi2,"reaxff/kk:d_C3dbopi2",nmax,maxbo); + MemKK::realloc_kokkos(d_C4dbopi2,"reaxff/kk:d_C4dbopi2",nmax,maxbo); - d_dBOp = typename AT::t_ffloat_2d_dl("reaxff/kk:dBOp",nmax,maxbo); + MemKK::realloc_kokkos(d_dBOp,"reaxff/kk:dBOp",nmax,maxbo); - d_dDeltap_self = typename AT::t_ffloat_2d_dl("reaxff/kk:dDeltap_self",nmax,3); - d_Deltap_boc = typename AT::t_ffloat_1d("reaxff/kk:Deltap_boc",nmax); - d_Deltap = typename AT::t_ffloat_1d("reaxff/kk:Deltap",nmax); - d_total_bo = typename AT::t_ffloat_1d("reaxff/kk:total_bo",nmax); + MemKK::realloc_kokkos(d_dDeltap_self,"reaxff/kk:dDeltap_self",nmax,3); + MemKK::realloc_kokkos(d_Deltap_boc,"reaxff/kk:Deltap_boc",nmax); + MemKK::realloc_kokkos(d_Deltap,"reaxff/kk:Deltap",nmax); + MemKK::realloc_kokkos(d_total_bo,"reaxff/kk:total_bo",nmax); - d_Cdbo = typename AT::t_ffloat_2d_dl("reaxff/kk:Cdbo",nmax,3*maxbo); - d_Cdbopi = typename AT::t_ffloat_2d_dl("reaxff/kk:Cdbopi",nmax,3*maxbo); - d_Cdbopi2 = typename AT::t_ffloat_2d_dl("reaxff/kk:Cdbopi2",nmax,3*maxbo); + MemKK::realloc_kokkos(d_Cdbo,"reaxff/kk:Cdbo",nmax,3*maxbo); + MemKK::realloc_kokkos(d_Cdbopi,"reaxff/kk:Cdbopi",nmax,3*maxbo); + MemKK::realloc_kokkos(d_Cdbopi2,"reaxff/kk:Cdbopi2",nmax,3*maxbo); - d_Delta = typename AT::t_ffloat_1d("reaxff/kk:Delta",nmax); - d_Delta_boc = typename AT::t_ffloat_1d("reaxff/kk:Delta_boc",nmax); - d_dDelta_lp = typename AT::t_ffloat_1d("reaxff/kk:dDelta_lp",nmax); - d_Delta_lp = typename AT::t_ffloat_1d("reaxff/kk:Delta_lp",nmax); - d_Delta_lp_temp = typename AT::t_ffloat_1d("reaxff/kk:Delta_lp_temp",nmax); - d_CdDelta = typename AT::t_ffloat_1d("reaxff/kk:CdDelta",nmax); - d_sum_ovun = typename AT::t_ffloat_2d_dl("reaxff/kk:sum_ovun",nmax,3); + MemKK::realloc_kokkos(d_Delta,"reaxff/kk:Delta",nmax); + MemKK::realloc_kokkos(d_Delta_boc,"reaxff/kk:Delta_boc",nmax); + MemKK::realloc_kokkos(d_dDelta_lp,"reaxff/kk:dDelta_lp",nmax); + MemKK::realloc_kokkos(d_Delta_lp,"reaxff/kk:Delta_lp",nmax); + MemKK::realloc_kokkos(d_Delta_lp_temp,"reaxff/kk:Delta_lp_temp",nmax); + MemKK::realloc_kokkos(d_CdDelta,"reaxff/kk:CdDelta",nmax); + MemKK::realloc_kokkos(d_sum_ovun,"reaxff/kk:sum_ovun",nmax,3); // FixReaxFFBonds - d_abo = typename AT::t_ffloat_2d("reaxff/kk:abo",nmax,maxbo); - d_neighid = typename AT::t_tagint_2d("reaxff/kk:neighid",nmax,maxbo); - d_numneigh_bonds = typename AT::t_int_1d("reaxff/kk:numneigh_bonds",nmax); + MemKK::realloc_kokkos(d_abo,"reaxff/kk:abo",nmax,maxbo); + MemKK::realloc_kokkos(d_neighid,"reaxff/kk:neighid",nmax,maxbo); + MemKK::realloc_kokkos(d_numneigh_bonds,"reaxff/kk:numneigh_bonds",nmax); // ComputeAngular intermediates - d_angular_intermediates = typename AT::t_ffloat_2d("reaxff/kk:angular_intermediates",nmax,4); -} - -/* ---------------------------------------------------------------------- */ - -template -void PairReaxFFKokkos::deallocate_array() -{ - if (cut_hbsq > 0.0) { - d_hb_first = typename AT::t_int_1d(); - d_hb_num = typename AT::t_int_1d(); - d_hb_list = typename AT::t_int_1d(); - } - d_bo_first = typename AT::t_int_1d(); - d_bo_num = typename AT::t_int_1d(); - d_bo_list = typename AT::t_int_1d(); - - d_BO = typename AT::t_ffloat_2d_dl(); - d_BO_s = typename AT::t_ffloat_2d_dl(); - d_BO_pi = typename AT::t_ffloat_2d_dl(); - d_BO_pi2 = typename AT::t_ffloat_2d_dl(); - - d_dln_BOp_pi = typename AT::t_ffloat_2d_dl(); - d_dln_BOp_pi2 = typename AT::t_ffloat_2d_dl(); - - d_C1dbo = typename AT::t_ffloat_2d_dl(); - d_C2dbo = typename AT::t_ffloat_2d_dl(); - d_C3dbo = typename AT::t_ffloat_2d_dl(); - - d_C1dbopi = typename AT::t_ffloat_2d_dl(); - d_C2dbopi = typename AT::t_ffloat_2d_dl(); - d_C3dbopi = typename AT::t_ffloat_2d_dl(); - d_C4dbopi = typename AT::t_ffloat_2d_dl(); - - d_C1dbopi2 = typename AT::t_ffloat_2d_dl(); - d_C2dbopi2 = typename AT::t_ffloat_2d_dl(); - d_C3dbopi2 = typename AT::t_ffloat_2d_dl(); - d_C4dbopi2 = typename AT::t_ffloat_2d_dl(); - - d_dBOp = typename AT::t_ffloat_2d_dl(); - - d_dDeltap_self = typename AT::t_ffloat_2d_dl(); - d_Deltap_boc = typename AT::t_ffloat_1d(); - d_Deltap = typename AT::t_ffloat_1d(); - d_total_bo = typename AT::t_ffloat_1d(); - - d_Cdbo = typename AT::t_ffloat_2d_dl(); - d_Cdbopi = typename AT::t_ffloat_2d_dl(); - d_Cdbopi2 = typename AT::t_ffloat_2d_dl(); - - d_Delta = typename AT::t_ffloat_1d(); - d_Delta_boc = typename AT::t_ffloat_1d(); - d_dDelta_lp = typename AT::t_ffloat_1d(); - d_Delta_lp = typename AT::t_ffloat_1d(); - d_Delta_lp_temp = typename AT::t_ffloat_1d(); - d_CdDelta = typename AT::t_ffloat_1d(); - d_sum_ovun = typename AT::t_ffloat_2d_dl(); - - // FixReaxFFBonds - d_abo = typename AT::t_ffloat_2d(); - d_neighid = typename AT::t_tagint_2d(); - d_numneigh_bonds = typename AT::t_int_1d(); - - // ComputeAngular intermediates - d_angular_intermediates = typename AT::t_ffloat_2d(); + MemKK::realloc_kokkos(d_angular_intermediates,"reaxff/kk:angular_intermediates",nmax,4); } /* ---------------------------------------------------------------------- */ diff --git a/src/KOKKOS/pair_reaxff_kokkos.h b/src/KOKKOS/pair_reaxff_kokkos.h index 64d9ced875..434f3c63fa 100644 --- a/src/KOKKOS/pair_reaxff_kokkos.h +++ b/src/KOKKOS/pair_reaxff_kokkos.h @@ -384,7 +384,6 @@ class PairReaxFFKokkos : public PairReaxFF { protected: void allocate(); void allocate_array(); - void deallocate_array(); void setup(); void init_md(); int Init_Lookup_Tables(); diff --git a/src/KOKKOS/pair_snap_kokkos.h b/src/KOKKOS/pair_snap_kokkos.h index 2cd0003478..2937359822 100644 --- a/src/KOKKOS/pair_snap_kokkos.h +++ b/src/KOKKOS/pair_snap_kokkos.h @@ -238,44 +238,14 @@ class PairSNAPKokkos : public PairSNAP { typename AT::t_efloat_1d d_eatom; typename AT::t_virial_array d_vatom; - typedef Kokkos::View t_bvec; - t_bvec bvec; - typedef Kokkos::View t_dbvec; - t_dbvec dbvec; SNAKokkos snaKK; int inum,max_neighs,chunk_size,chunk_offset; - int host_flag; + int host_flag,neighflag; int eflag,vflag; void allocate() override; - //void read_files(char *, char *); - /*template - inline int equal(double* x,double* y); - template - inline double dist2(double* x,double* y); - double extra_cutoff(); - void load_balance(); - void set_sna_to_shared(int snaid,int i); - void build_per_atom_arrays();*/ - - int neighflag; - - Kokkos::View ilistmast; - Kokkos::View ghostilist; - Kokkos::View ghostnumneigh; - Kokkos::View ghostneighs; - Kokkos::View ghostfirstneigh; - - Kokkos::View i_pairs; - Kokkos::View i_rij; - Kokkos::View i_inside; - Kokkos::View i_wj; - Kokkos::Viewi_rcutij; - Kokkos::View i_ninside; - Kokkos::View i_uarraytot_r, i_uarraytot_i; - Kokkos::View i_zarray_r, i_zarray_i; Kokkos::View d_radelem; // element radii Kokkos::View d_wjelem; // elements weights @@ -286,7 +256,6 @@ class PairSNAPKokkos : public PairSNAP { Kokkos::View d_ninside; // ninside for all atoms in list Kokkos::View d_beta; // betas for all atoms in list Kokkos::View d_beta_pack; // betas for all atoms in list, GPU - Kokkos::View d_bispectrum; // bispectrum components for all atoms in list typedef Kokkos::DualView tdual_fparams; tdual_fparams k_cutsq; diff --git a/src/KOKKOS/pair_snap_kokkos_impl.h b/src/KOKKOS/pair_snap_kokkos_impl.h index c2657f8534..0656a1f9ee 100644 --- a/src/KOKKOS/pair_snap_kokkos_impl.h +++ b/src/KOKKOS/pair_snap_kokkos_impl.h @@ -206,10 +206,10 @@ void PairSNAPKokkos::compute(int eflag_in, if (beta_max < inum) { beta_max = inum; - d_beta = Kokkos::View("PairSNAPKokkos:beta",ncoeff,inum); + MemKK::realloc_kokkos(d_beta,"PairSNAPKokkos:beta",ncoeff,inum); if (!host_flag) - d_beta_pack = Kokkos::View("PairSNAPKokkos:beta_pack",vector_length,ncoeff,(inum + vector_length - 1) / vector_length); - d_ninside = Kokkos::View("PairSNAPKokkos:ninside",inum); + MemKK::realloc_kokkos(d_beta_pack,"PairSNAPKokkos:beta_pack",vector_length,ncoeff,(inum + vector_length - 1) / vector_length); + MemKK::realloc_kokkos(d_ninside,"PairSNAPKokkos:ninside",inum); } chunk_size = MIN(chunksize,inum); // "chunksize" variable is set by user @@ -545,7 +545,7 @@ void PairSNAPKokkos::allocate() PairSNAP::allocate(); int n = atom->ntypes; - d_map = Kokkos::View("PairSNAPKokkos::map",n+1); + MemKK::realloc_kokkos(d_map,"PairSNAPKokkos::map",n+1); } @@ -574,11 +574,11 @@ void PairSNAPKokkos::coeff(int narg, char // Set up element lists - d_radelem = Kokkos::View("pair:radelem",nelements); - d_wjelem = Kokkos::View("pair:wjelem",nelements); - d_coeffelem = Kokkos::View("pair:coeffelem",nelements,ncoeffall); - d_sinnerelem = Kokkos::View("pair:sinnerelem",nelements); - d_dinnerelem = Kokkos::View("pair:dinnerelem",nelements); + MemKK::realloc_kokkos(d_radelem,"pair:radelem",nelements); + MemKK::realloc_kokkos(d_wjelem,"pair:wjelem",nelements); + MemKK::realloc_kokkos(d_coeffelem,"pair:coeffelem",nelements,ncoeffall); + MemKK::realloc_kokkos(d_sinnerelem,"pair:sinnerelem",nelements); + MemKK::realloc_kokkos(d_dinnerelem,"pair:dinnerelem",nelements); auto h_radelem = Kokkos::create_mirror_view(d_radelem); auto h_wjelem = Kokkos::create_mirror_view(d_wjelem); @@ -1411,12 +1411,16 @@ template double PairSNAPKokkos::memory_usage() { double bytes = Pair::memory_usage(); - int n = atom->ntypes+1; - bytes += n*n*sizeof(int); - bytes += n*n*sizeof(real_type); - bytes += (2*ncoeffall)*sizeof(real_type); - bytes += (ncoeff*3)*sizeof(real_type); - bytes += snaKK.memory_usage(); + bytes += MemKK::memory_usage(d_beta); + if (!host_flag) + bytes += MemKK::memory_usage(d_beta_pack); + bytes += MemKK::memory_usage(d_ninside); + bytes += MemKK::memory_usage(d_map); + bytes += MemKK::memory_usage(d_radelem); + bytes += MemKK::memory_usage(d_wjelem); + bytes += MemKK::memory_usage(d_coeffelem); + bytes += MemKK::memory_usage(d_sinnerelem); + bytes += MemKK::memory_usage(d_dinnerelem); return bytes; } diff --git a/src/KOKKOS/sna_kokkos_impl.h b/src/KOKKOS/sna_kokkos_impl.h index 77130b9781..8d81a4a65b 100644 --- a/src/KOKKOS/sna_kokkos_impl.h +++ b/src/KOKKOS/sna_kokkos_impl.h @@ -17,6 +17,7 @@ ------------------------------------------------------------------------- */ #include "sna_kokkos.h" +#include "memory_kokkos.h" #include #include #include @@ -62,12 +63,12 @@ SNAKokkos::SNAKokkos(real_type rfac0_in, build_indexlist(); int jdimpq = twojmax + 2; - rootpqarray = t_sna_2d("SNAKokkos::rootpqarray",jdimpq,jdimpq); + MemKK::realloc_kokkos(rootpqarray,"SNAKokkos::rootpqarray",jdimpq,jdimpq); - cglist = t_sna_1d("SNAKokkos::cglist",idxcg_max); + MemKK::realloc_kokkos(cglist,"SNAKokkos::cglist",idxcg_max); if (bzero_flag) { - bzero = Kokkos::View("sna:bzero",twojmax+1); + MemKK::realloc_kokkos(bzero,"sna:bzero",twojmax+1); auto h_bzero = Kokkos::create_mirror_view(bzero); double www = wself*wself*wself; @@ -95,7 +96,7 @@ void SNAKokkos::build_indexlist() // index list for cglist int jdim = twojmax + 1; - idxcg_block = Kokkos::View(Kokkos::NoInit("SNAKokkos::idxcg_block"),jdim,jdim,jdim); + MemKK::realloc_kokkos(idxcg_block,"SNAKokkos::idxcg_block",jdim,jdim,jdim); auto h_idxcg_block = Kokkos::create_mirror_view(idxcg_block); int idxcg_count = 0; @@ -113,7 +114,7 @@ void SNAKokkos::build_indexlist() // index list for uarray // need to include both halves - idxu_block = Kokkos::View(Kokkos::NoInit("SNAKokkos::idxu_block"),jdim); + MemKK::realloc_kokkos(idxu_block,"SNAKokkos::idxu_block",jdim); auto h_idxu_block = Kokkos::create_mirror_view(idxu_block); int idxu_count = 0; @@ -128,7 +129,7 @@ void SNAKokkos::build_indexlist() Kokkos::deep_copy(idxu_block,h_idxu_block); // index list for half uarray - idxu_half_block = Kokkos::View(Kokkos::NoInit("SNAKokkos::idxu_half_block"),jdim); + MemKK::realloc_kokkos(idxu_half_block,"SNAKokkos::idxu_half_block",jdim); auto h_idxu_half_block = Kokkos::create_mirror_view(idxu_half_block); int idxu_half_count = 0; @@ -142,7 +143,7 @@ void SNAKokkos::build_indexlist() Kokkos::deep_copy(idxu_half_block, h_idxu_half_block); // mapping between full and half indexing, encoding flipping - idxu_full_half = Kokkos::View(Kokkos::NoInit("SNAKokkos::idxu_full_half"),idxu_max); + MemKK::realloc_kokkos(idxu_full_half,"SNAKokkos::idxu_full_half",idxu_max); auto h_idxu_full_half = Kokkos::create_mirror_view(idxu_full_half); idxu_count = 0; @@ -169,7 +170,7 @@ void SNAKokkos::build_indexlist() // index list for "cache" uarray // this is the GPU scratch memory requirements // applied the CPU structures - idxu_cache_block = Kokkos::View(Kokkos::NoInit("SNAKokkos::idxu_cache_block"),jdim); + MemKK::realloc_kokkos(idxu_cache_block,"SNAKokkos::idxu_cache_block",jdim); auto h_idxu_cache_block = Kokkos::create_mirror_view(idxu_cache_block); int idxu_cache_count = 0; @@ -191,7 +192,7 @@ void SNAKokkos::build_indexlist() if (j >= j1) idxb_count++; idxb_max = idxb_count; - idxb = Kokkos::View(Kokkos::NoInit("SNAKokkos::idxb"),idxb_max); + MemKK::realloc_kokkos(idxb,"SNAKokkos::idxb",idxb_max); auto h_idxb = Kokkos::create_mirror_view(idxb); idxb_count = 0; @@ -208,7 +209,7 @@ void SNAKokkos::build_indexlist() // reverse index list for beta and b - idxb_block = Kokkos::View(Kokkos::NoInit("SNAKokkos::idxb_block"),jdim,jdim,jdim); + MemKK::realloc_kokkos(idxb_block,"SNAKokkos::idxb_block",jdim,jdim,jdim); auto h_idxb_block = Kokkos::create_mirror_view(idxb_block); idxb_count = 0; @@ -234,10 +235,10 @@ void SNAKokkos::build_indexlist() idxz_count++; idxz_max = idxz_count; - idxz = Kokkos::View(Kokkos::NoInit("SNAKokkos::idxz"),idxz_max); + MemKK::realloc_kokkos(idxz,"SNAKokkos::idxz",idxz_max); auto h_idxz = Kokkos::create_mirror_view(idxz); - idxz_block = Kokkos::View(Kokkos::NoInit("SNAKokkos::idxz_block"), jdim,jdim,jdim); + MemKK::realloc_kokkos(idxz_block,"SNAKokkos::idxz_block", jdim,jdim,jdim); auto h_idxz_block = Kokkos::create_mirror_view(idxz_block); idxz_count = 0; @@ -294,59 +295,59 @@ void SNAKokkos::grow_rij(int newnatom, int natom = newnatom; nmax = newnmax; - rij = t_sna_3d(Kokkos::NoInit("sna:rij"),natom,nmax,3); - wj = t_sna_2d(Kokkos::NoInit("sna:wj"),natom,nmax); - rcutij = t_sna_2d(Kokkos::NoInit("sna:rcutij"),natom,nmax); - sinnerij = t_sna_2d(Kokkos::NoInit("sna:sinnerij"),natom,nmax); - dinnerij = t_sna_2d(Kokkos::NoInit("sna:dinnerij"),natom,nmax); - inside = t_sna_2i(Kokkos::NoInit("sna:inside"),natom,nmax); - element = t_sna_2i(Kokkos::NoInit("sna:element"),natom,nmax); - dedr = t_sna_3d(Kokkos::NoInit("sna:dedr"),natom,nmax,3); + MemKK::realloc_kokkos(rij,"sna:rij",natom,nmax,3); + MemKK::realloc_kokkos(wj,"sna:wj",natom,nmax); + MemKK::realloc_kokkos(rcutij,"sna:rcutij",natom,nmax); + MemKK::realloc_kokkos(sinnerij,"sna:sinnerij",natom,nmax); + MemKK::realloc_kokkos(dinnerij,"sna:dinnerij",natom,nmax); + MemKK::realloc_kokkos(inside,"sna:inside",natom,nmax); + MemKK::realloc_kokkos(element,"sna:element",natom,nmax); + MemKK::realloc_kokkos(dedr,"sna:dedr",natom,nmax,3); #ifdef LMP_KOKKOS_GPU if (!host_flag) { const int natom_div = (natom + vector_length - 1) / vector_length; - a_pack = t_sna_3c_ll(Kokkos::NoInit("sna:a_pack"),vector_length,nmax,natom_div); - b_pack = t_sna_3c_ll(Kokkos::NoInit("sna:b_pack"),vector_length,nmax,natom_div); - da_pack = t_sna_4c_ll(Kokkos::NoInit("sna:da_pack"),vector_length,nmax,natom_div,3); - db_pack = t_sna_4c_ll(Kokkos::NoInit("sna:db_pack"),vector_length,nmax,natom_div,3); - sfac_pack = t_sna_4d_ll(Kokkos::NoInit("sna:sfac_pack"),vector_length,nmax,natom_div,4); - ulisttot = t_sna_3c_ll(Kokkos::NoInit("sna:ulisttot"),1,1,1); // dummy allocation - ulisttot_full = t_sna_3c_ll(Kokkos::NoInit("sna:ulisttot"),1,1,1); - ulisttot_re_pack = t_sna_4d_ll(Kokkos::NoInit("sna:ulisttot_re_pack"),vector_length,idxu_half_max,nelements,natom_div); - ulisttot_im_pack = t_sna_4d_ll(Kokkos::NoInit("sna:ulisttot_im_pack"),vector_length,idxu_half_max,nelements,natom_div); - ulisttot_pack = t_sna_4c_ll(Kokkos::NoInit("sna:ulisttot_pack"),vector_length,idxu_max,nelements,natom_div); - ulist = t_sna_3c_ll(Kokkos::NoInit("sna:ulist"),1,1,1); - zlist = t_sna_3c_ll(Kokkos::NoInit("sna:zlist"),1,1,1); - zlist_pack = t_sna_4c_ll(Kokkos::NoInit("sna:zlist_pack"),vector_length,idxz_max,ndoubles,natom_div); - blist = t_sna_3d(Kokkos::NoInit("sna:blist"),natom,ntriples,idxb_max); - blist_pack = t_sna_4d_ll(Kokkos::NoInit("sna:blist_pack"),vector_length,idxb_max,ntriples,natom_div); - ylist = t_sna_3c_ll(Kokkos::NoInit("sna:ylist"),1,1,1); - ylist_pack_re = t_sna_4d_ll(Kokkos::NoInit("sna:ylist_pack_re"),vector_length,idxu_half_max,nelements,natom_div); - ylist_pack_im = t_sna_4d_ll(Kokkos::NoInit("sna:ylist_pack_im"),vector_length,idxu_half_max,nelements,natom_div); - dulist = t_sna_4c3_ll(Kokkos::NoInit("sna:dulist"),1,1,1); + MemKK::realloc_kokkos(a_pack,"sna:a_pack",vector_length,nmax,natom_div); + MemKK::realloc_kokkos(b_pack,"sna:b_pack",vector_length,nmax,natom_div); + MemKK::realloc_kokkos(da_pack,"sna:da_pack",vector_length,nmax,natom_div,3); + MemKK::realloc_kokkos(db_pack,"sna:db_pack",vector_length,nmax,natom_div,3); + MemKK::realloc_kokkos(sfac_pack,"sna:sfac_pack",vector_length,nmax,natom_div,4); + MemKK::realloc_kokkos(ulisttot,"sna:ulisttot",1,1,1); // dummy allocation + MemKK::realloc_kokkos(ulisttot_full,"sna:ulisttot",1,1,1); + MemKK::realloc_kokkos(ulisttot_re_pack,"sna:ulisttot_re_pack",vector_length,idxu_half_max,nelements,natom_div); + MemKK::realloc_kokkos(ulisttot_im_pack,"sna:ulisttot_im_pack",vector_length,idxu_half_max,nelements,natom_div); + MemKK::realloc_kokkos(ulisttot_pack,"sna:ulisttot_pack",vector_length,idxu_max,nelements,natom_div); + MemKK::realloc_kokkos(ulist,"sna:ulist",1,1,1); + MemKK::realloc_kokkos(zlist,"sna:zlist",1,1,1); + MemKK::realloc_kokkos(zlist_pack,"sna:zlist_pack",vector_length,idxz_max,ndoubles,natom_div); + MemKK::realloc_kokkos(blist,"sna:blist",natom,ntriples,idxb_max); + MemKK::realloc_kokkos(blist_pack,"sna:blist_pack",vector_length,idxb_max,ntriples,natom_div); + MemKK::realloc_kokkos(ylist,"sna:ylist",1,1,1); + MemKK::realloc_kokkos(ylist_pack_re,"sna:ylist_pack_re",vector_length,idxu_half_max,nelements,natom_div); + MemKK::realloc_kokkos(ylist_pack_im,"sna:ylist_pack_im",vector_length,idxu_half_max,nelements,natom_div); + MemKK::realloc_kokkos(dulist,"sna:dulist",1,1,1); } else { #endif - a_pack = t_sna_3c_ll(Kokkos::NoInit("sna:a_pack"),1,1,1); - b_pack = t_sna_3c_ll(Kokkos::NoInit("sna:b_pack"),1,1,1); - da_pack = t_sna_4c_ll(Kokkos::NoInit("sna:da_pack"),1,1,1,1); - db_pack = t_sna_4c_ll(Kokkos::NoInit("sna:db_pack"),1,1,1,1); - sfac_pack = t_sna_4d_ll(Kokkos::NoInit("sna:sfac_pack"),1,1,1,1); - ulisttot = t_sna_3c_ll(Kokkos::NoInit("sna:ulisttot"),idxu_half_max,nelements,natom); - ulisttot_full = t_sna_3c_ll(Kokkos::NoInit("sna:ulisttot_full"),idxu_max,nelements,natom); - ulisttot_re_pack = t_sna_4d_ll(Kokkos::NoInit("sna:ulisttot_re"),1,1,1,1); - ulisttot_im_pack = t_sna_4d_ll(Kokkos::NoInit("sna:ulisttot_im"),1,1,1,1); - ulisttot_pack = t_sna_4c_ll(Kokkos::NoInit("sna:ulisttot_pack"),1,1,1,1); - ulist = t_sna_3c_ll(Kokkos::NoInit("sna:ulist"),idxu_cache_max,natom,nmax); - zlist = t_sna_3c_ll(Kokkos::NoInit("sna:zlist"),idxz_max,ndoubles,natom); - zlist_pack = t_sna_4c_ll(Kokkos::NoInit("sna:zlist_pack"),1,1,1,1); - blist = t_sna_3d(Kokkos::NoInit("sna:blist"),natom,ntriples,idxb_max); - blist_pack = t_sna_4d_ll(Kokkos::NoInit("sna:blist_pack"),1,1,1,1); - ylist = t_sna_3c_ll(Kokkos::NoInit("sna:ylist"),idxu_half_max,nelements,natom); - ylist_pack_re = t_sna_4d_ll(Kokkos::NoInit("sna:ylist_pack_re"),1,1,1,1); - ylist_pack_im = t_sna_4d_ll(Kokkos::NoInit("sna:ylist_pack_im"),1,1,1,1); - dulist = t_sna_4c3_ll(Kokkos::NoInit("sna:dulist"),idxu_cache_max,natom,nmax); + MemKK::realloc_kokkos(a_pack,"sna:a_pack",1,1,1); + MemKK::realloc_kokkos(b_pack,"sna:b_pack",1,1,1); + MemKK::realloc_kokkos(da_pack,"sna:da_pack",1,1,1,1); + MemKK::realloc_kokkos(db_pack,"sna:db_pack",1,1,1,1); + MemKK::realloc_kokkos(sfac_pack,"sna:sfac_pack",1,1,1,1); + MemKK::realloc_kokkos(ulisttot,"sna:ulisttot",idxu_half_max,nelements,natom); + MemKK::realloc_kokkos(ulisttot_full,"sna:ulisttot_full",idxu_max,nelements,natom); + MemKK::realloc_kokkos(ulisttot_re_pack,"sna:ulisttot_re",1,1,1,1); + MemKK::realloc_kokkos(ulisttot_im_pack,"sna:ulisttot_im",1,1,1,1); + MemKK::realloc_kokkos(ulisttot_pack,"sna:ulisttot_pack",1,1,1,1); + MemKK::realloc_kokkos(ulist,"sna:ulist",idxu_cache_max,natom,nmax); + MemKK::realloc_kokkos(zlist,"sna:zlist",idxz_max,ndoubles,natom); + MemKK::realloc_kokkos(zlist_pack,"sna:zlist_pack",1,1,1,1); + MemKK::realloc_kokkos(blist,"sna:blist",natom,ntriples,idxb_max); + MemKK::realloc_kokkos(blist_pack,"sna:blist_pack",1,1,1,1); + MemKK::realloc_kokkos(ylist,"sna:ylist",idxu_half_max,nelements,natom); + MemKK::realloc_kokkos(ylist_pack_re,"sna:ylist_pack_re",1,1,1,1); + MemKK::realloc_kokkos(ylist_pack_im,"sna:ylist_pack_im",1,1,1,1); + MemKK::realloc_kokkos(dulist,"sna:dulist",idxu_cache_max,natom,nmax); #ifdef LMP_KOKKOS_GPU } @@ -2356,74 +2357,68 @@ void SNAKokkos::compute_s_dsfac(const real template double SNAKokkos::memory_usage() { - int jdimpq = twojmax + 2; - int jdim = twojmax + 1; - double bytes; + double bytes = 0; - bytes = 0; - - bytes += jdimpq*jdimpq * sizeof(real_type); // pqarray - bytes += idxcg_max * sizeof(real_type); // cglist + bytes += MemKK::memory_usage(rootpqarray); + bytes += MemKK::memory_usage(cglist); #ifdef LMP_KOKKOS_GPU if (!host_flag) { - auto natom_pad = (natom+vector_length-1)/vector_length; - - bytes += natom_pad * nmax * sizeof(real_type) * 2; // a_pack - bytes += natom_pad * nmax * sizeof(real_type) * 2; // b_pack - bytes += natom_pad * nmax * 3 * sizeof(real_type) * 2; // da_pack - bytes += natom_pad * nmax * 3 * sizeof(real_type) * 2; // db_pack - bytes += natom_pad * nmax * 4 * sizeof(real_type); // sfac_pack + bytes += MemKK::memory_usage(a_pack); + bytes += MemKK::memory_usage(b_pack); + bytes += MemKK::memory_usage(da_pack); + bytes += MemKK::memory_usage(db_pack); + bytes += MemKK::memory_usage(sfac_pack); - bytes += natom_pad * idxu_half_max * nelements * sizeof(real_type); // ulisttot_re_pack - bytes += natom_pad * idxu_half_max * nelements * sizeof(real_type); // ulisttot_im_pack - bytes += natom_pad * idxu_max * nelements * sizeof(real_type) * 2; // ulisttot_pack + bytes += MemKK::memory_usage(ulisttot_re_pack); + bytes += MemKK::memory_usage(ulisttot_im_pack); + bytes += MemKK::memory_usage(ulisttot_pack); - bytes += natom_pad * idxz_max * ndoubles * sizeof(real_type) * 2; // zlist_pack - bytes += natom_pad * idxb_max * ntriples * sizeof(real_type); // blist_pack + bytes += MemKK::memory_usage(zlist_pack); + bytes += MemKK::memory_usage(blist_pack); - bytes += natom_pad * idxu_half_max * nelements * sizeof(real_type); // ylist_pack_re - bytes += natom_pad * idxu_half_max * nelements * sizeof(real_type); // ylist_pack_im + bytes += MemKK::memory_usage(ylist_pack_re); + bytes += MemKK::memory_usage(ylist_pack_im); } else { #endif - bytes += natom * nmax * idxu_cache_max * sizeof(real_type) * 2; // ulist - bytes += natom * idxu_half_max * nelements * sizeof(real_type) * 2; // ulisttot - bytes += natom * idxu_max * nelements * sizeof(real_type) * 2; // ulisttot_full + bytes += MemKK::memory_usage(ulist); + bytes += MemKK::memory_usage(ulisttot); + bytes += MemKK::memory_usage(ulisttot_full); - bytes += natom * idxz_max * ndoubles * sizeof(real_type) * 2; // zlist - bytes += natom * idxb_max * ntriples * sizeof(real_type); // blist + bytes += MemKK::memory_usage(zlist); + bytes += MemKK::memory_usage(blist); - bytes += natom * idxu_half_max * nelements * sizeof(real_type) * 2; // ylist + bytes += MemKK::memory_usage(ylist); - bytes += natom * nmax * idxu_cache_max * 3 * sizeof(real_type) * 2; // dulist + bytes += MemKK::memory_usage(dulist); #ifdef LMP_KOKKOS_GPU } #endif - bytes += natom * nmax * 3 * sizeof(real_type); // dedr + bytes += MemKK::memory_usage(dedr); - bytes += jdim * jdim * jdim * sizeof(int); // idxcg_block - bytes += jdim * sizeof(int); // idxu_block - bytes += jdim * sizeof(int); // idxu_half_block - bytes += idxu_max * sizeof(FullHalfMapper); // idxu_full_half - bytes += jdim * sizeof(int); // idxu_cache_block - bytes += jdim * jdim * jdim * sizeof(int); // idxz_block - bytes += jdim * jdim * jdim * sizeof(int); // idxb_block + bytes += MemKK::memory_usage(idxcg_block); + bytes += MemKK::memory_usage(idxu_block); + bytes += MemKK::memory_usage(idxu_half_block); + bytes += MemKK::memory_usage(idxu_full_half); + bytes += MemKK::memory_usage(idxu_cache_block); + bytes += MemKK::memory_usage(idxz_block); + bytes += MemKK::memory_usage(idxb_block); - bytes += idxz_max * 10 * sizeof(int); // idxz - bytes += idxb_max * 3 * sizeof(int); // idxb + bytes += MemKK::memory_usage(idxz); + bytes += MemKK::memory_usage(idxb); - bytes += jdim * sizeof(real_type); // bzero + bytes += MemKK::memory_usage(bzero); - bytes += natom * nmax * 3 * sizeof(real_type); // rij - bytes += natom * nmax * sizeof(real_type); // inside - bytes += natom * nmax * sizeof(real_type); // wj - bytes += natom * nmax * sizeof(real_type); // rcutij - bytes += natom * nmax * sizeof(real_type); // sinnerij - bytes += natom * nmax * sizeof(real_type); // dinnerij + bytes += MemKK::memory_usage(rij); + bytes += MemKK::memory_usage(inside); + bytes += MemKK::memory_usage(wj); + bytes += MemKK::memory_usage(rcutij); + bytes += MemKK::memory_usage(sinnerij); + bytes += MemKK::memory_usage(dinnerij); return bytes; } From d8d6884defef6c5b08c91c98c8259a6eb3599724 Mon Sep 17 00:00:00 2001 From: Stan Gerald Moore Date: Thu, 19 May 2022 09:09:57 -0600 Subject: [PATCH 168/585] Remove use_count check, reduce memory use in ReaxFF --- src/KOKKOS/memory_kokkos.h | 6 ---- src/KOKKOS/pair_reaxff_kokkos.cpp | 58 +++++++++++-------------------- src/KOKKOS/pair_reaxff_kokkos.h | 22 +++++------- 3 files changed, 29 insertions(+), 57 deletions(-) diff --git a/src/KOKKOS/memory_kokkos.h b/src/KOKKOS/memory_kokkos.h index 092e20b6c7..4d4d200745 100644 --- a/src/KOKKOS/memory_kokkos.h +++ b/src/KOKKOS/memory_kokkos.h @@ -284,7 +284,6 @@ template static void realloc_kokkos(TYPE &data, const char *name, int n1) { data = TYPE(); - assert(data.use_count() == 0); data = TYPE(Kokkos::NoInit(std::string(name)),n1); } @@ -292,7 +291,6 @@ template static void realloc_kokkos(TYPE &data, const char *name, int n1, int n2) { data = TYPE(); - assert(data.use_count() == 0); data = TYPE(Kokkos::NoInit(std::string(name)),n1,n2); } @@ -300,7 +298,6 @@ template static void realloc_kokkos(TYPE &data, const char *name, int n1, int n2, int n3) { data = TYPE(); - assert(data.use_count() == 0); data = TYPE(Kokkos::NoInit(std::string(name)),n1,n2,n3); } @@ -308,7 +305,6 @@ template static void realloc_kokkos(TYPE &data, const char *name, int n1, int n2, int n3, int n4) { data = TYPE(); - assert(data.use_count() == 0); data = TYPE(Kokkos::NoInit(std::string(name)),n1,n2,n3,n4); } @@ -316,7 +312,6 @@ template static void realloc_kokkos(TYPE &data, const char *name, int n1, int n2, int n3, int n4, int n5) { data = TYPE(); - assert(data.use_count() == 0); data = TYPE(Kokkos::NoInit(std::string(name)),n1,n2,n3,n4,n5); } @@ -324,7 +319,6 @@ template static void realloc_kokkos(TYPE &data, const char *name, int n1, int n2, int n3, int n4, int n5, int n6) { data = TYPE(); - assert(data.use_count() == 0); data = TYPE(Kokkos::NoInit(std::string(name)),n1,n2,n3,n4,n5,n6); } diff --git a/src/KOKKOS/pair_reaxff_kokkos.cpp b/src/KOKKOS/pair_reaxff_kokkos.cpp index 7f905c069f..61f3bb3037 100644 --- a/src/KOKKOS/pair_reaxff_kokkos.cpp +++ b/src/KOKKOS/pair_reaxff_kokkos.cpp @@ -884,17 +884,10 @@ void PairReaxFFKokkos::compute(int eflag_in, int vflag_in) Kokkos::parallel_for(Kokkos::RangePolicy(0,ignum),*this); // allocate duplicated memory - if (need_dup) { + if (need_dup) dup_CdDelta = Kokkos::Experimental::create_scatter_view(d_CdDelta); - //dup_Cdbo = Kokkos::Experimental::create_scatter_view(d_Cdbo); - //dup_Cdbopi = Kokkos::Experimental::create_scatter_view(d_Cdbopi); - //dup_Cdbopi2 = Kokkos::Experimental::create_scatter_view(d_Cdbopi2); - } else { + else ndup_CdDelta = Kokkos::Experimental::create_scatter_view(d_CdDelta); - //ndup_Cdbo = Kokkos::Experimental::create_scatter_view(d_Cdbo); - //ndup_Cdbopi = Kokkos::Experimental::create_scatter_view(d_Cdbopi); - //ndup_Cdbopi2 = Kokkos::Experimental::create_scatter_view(d_Cdbopi2); - } // reduction over duplicated memory if (need_dup) @@ -1034,26 +1027,12 @@ void PairReaxFFKokkos::compute(int eflag_in, int vflag_in) if (need_dup) { Kokkos::Experimental::contribute(d_dDeltap_self, dup_dDeltap_self); // needed in ComputeBond2 Kokkos::Experimental::contribute(d_CdDelta, dup_CdDelta); // needed in ComputeBond2 - - //Kokkos::Experimental::contribute(d_Cdbo, dup_Cdbo); // needed in UpdateBond, but also used in UpdateBond - //Kokkos::Experimental::contribute(d_Cdbopi, dup_Cdbopi); // needed in UpdateBond, but also used in UpdateBond - //Kokkos::Experimental::contribute(d_Cdbopi2, dup_Cdbopi2); // needed in UpdateBond, but also used in UpdateBond - //dup_Cdbo.reset_except(d_Cdbo); - //dup_Cdbopi.reset_except(d_Cdbopi); - //dup_Cdbopi2.reset_except(d_Cdbopi2); } // Bond force if (neighflag == HALF) { Kokkos::parallel_for(Kokkos::RangePolicy>(0,ignum),*this); - // reduction over duplicated memory - //if (need_dup) { - // Kokkos::Experimental::contribute(d_Cdbo, dup_Cdbo); // needed in ComputeBond2 - // Kokkos::Experimental::contribute(d_Cdbopi, dup_Cdbopi); // needed in ComputeBond2 - // Kokkos::Experimental::contribute(d_Cdbopi2, dup_Cdbopi2); // needed in ComputeBond2 - //} - if (vflag_either) Kokkos::parallel_reduce(Kokkos::RangePolicy>(0,ignum),*this,ev); else @@ -1063,13 +1042,6 @@ void PairReaxFFKokkos::compute(int eflag_in, int vflag_in) } else { //if (neighflag == HALFTHREAD) { Kokkos::parallel_for(Kokkos::RangePolicy>(0,ignum),*this); - // reduction over duplicated memory - //if (need_dup) { - // Kokkos::Experimental::contribute(d_Cdbo, dup_Cdbo); // needed in ComputeBond2 - // Kokkos::Experimental::contribute(d_Cdbopi, dup_Cdbopi); // needed in ComputeBond2 - // Kokkos::Experimental::contribute(d_Cdbopi2, dup_Cdbopi2); // needed in ComputeBond2 - //} - if (vflag_either) Kokkos::parallel_reduce(Kokkos::RangePolicy>(0,ignum),*this,ev); else @@ -1117,7 +1089,7 @@ void PairReaxFFKokkos::compute(int eflag_in, int vflag_in) copymode = 0; - // free duplicated memory + // free scatterview memory if (need_dup) { dup_f = decltype(dup_f)(); dup_eatom = decltype(dup_eatom)(); @@ -1125,9 +1097,13 @@ void PairReaxFFKokkos::compute(int eflag_in, int vflag_in) dup_dDeltap_self = decltype(dup_dDeltap_self)(); dup_total_bo = decltype(dup_total_bo)(); dup_CdDelta = decltype(dup_CdDelta)(); - //dup_Cdbo = decltype(dup_Cdbo)(); - //dup_Cdbopi = decltype(dup_Cdbopi)(); - //dup_Cdbopi2 = decltype(dup_Cdbopi2)(); + } else { + ndup_f = decltype(ndup_f)(); + ndup_eatom = decltype(ndup_eatom)(); + ndup_vatom = decltype(ndup_vatom)(); + ndup_dDeltap_self = decltype(ndup_dDeltap_self)(); + ndup_total_bo = decltype(ndup_total_bo)(); + ndup_CdDelta = decltype(ndup_CdDelta)(); } d_neighbors = typename AT::t_neighbors_2d(); @@ -1513,6 +1489,17 @@ void PairReaxFFKokkos::operator()(TagPairReaxComputeTabulatedLJCoulo template void PairReaxFFKokkos::allocate_array() { + // free scatterview memory + if (need_dup) { + dup_dDeltap_self = decltype(dup_dDeltap_self)(); + dup_total_bo = decltype(dup_total_bo)(); + dup_CdDelta = decltype(dup_CdDelta)(); + } else { + ndup_dDeltap_self = decltype(ndup_dDeltap_self)(); + ndup_total_bo = decltype(ndup_total_bo)(); + ndup_CdDelta = decltype(ndup_CdDelta)(); + } + if (cut_hbsq > 0.0) { MemKK::realloc_kokkos(d_hb_first,"reaxff/kk:hb_first",nmax); MemKK::realloc_kokkos(d_hb_num,"reaxff/kk:hb_num",nmax); @@ -3482,9 +3469,6 @@ void PairReaxFFKokkos::operator()(TagPairReaxUpdateBond, Kokkos::View::value>> a_Cdbo = d_Cdbo; Kokkos::View::value>> a_Cdbopi = d_Cdbopi; Kokkos::View::value>> a_Cdbopi2 = d_Cdbopi2; - //auto a_Cdbo = dup_Cdbo.template access>(); - //auto a_Cdbopi = dup_Cdbopi.template access>(); - //auto a_Cdbopi2 = dup_Cdbopi2.template access>(); const int i = d_ilist[ii]; const tagint itag = tag(i); diff --git a/src/KOKKOS/pair_reaxff_kokkos.h b/src/KOKKOS/pair_reaxff_kokkos.h index 434f3c63fa..39b323a0fe 100644 --- a/src/KOKKOS/pair_reaxff_kokkos.h +++ b/src/KOKKOS/pair_reaxff_kokkos.h @@ -435,6 +435,8 @@ class PairReaxFFKokkos : public PairReaxFF { typename AT::t_ffloat_2d_dl d_C1dbopi2, d_C2dbopi2, d_C3dbopi2, d_C4dbopi2; typename AT::t_ffloat_2d_dl d_Cdbo, d_Cdbopi, d_Cdbopi2, d_dDeltap_self; + int need_dup; + using KKDeviceType = typename KKDevice::value; template @@ -443,27 +445,19 @@ class PairReaxFFKokkos : public PairReaxFF { template using NonDupScatterView = KKScatterView; - DupScatterView dup_total_bo; - DupScatterView dup_CdDelta; - DupScatterView dup_eatom; DupScatterView dup_f; + DupScatterView dup_eatom; DupScatterView dup_vatom; DupScatterView dup_dDeltap_self; - DupScatterView dup_Cdbo; - DupScatterView dup_Cdbopi; - DupScatterView dup_Cdbopi2; + DupScatterView dup_total_bo; + DupScatterView dup_CdDelta; - NonDupScatterView ndup_total_bo; - NonDupScatterView ndup_CdDelta; - NonDupScatterView ndup_eatom; NonDupScatterView ndup_f; + NonDupScatterView ndup_eatom; NonDupScatterView ndup_vatom; NonDupScatterView ndup_dDeltap_self; - NonDupScatterView ndup_Cdbo; - NonDupScatterView ndup_Cdbopi; - NonDupScatterView ndup_Cdbopi2; - - int need_dup; + NonDupScatterView ndup_total_bo; + NonDupScatterView ndup_CdDelta; typedef Kokkos::DualView tdual_ffloat_2d_n7; typedef typename tdual_ffloat_2d_n7::t_dev_const_randomread t_ffloat_2d_n7_randomread; From a9431208a267737215ab22bb1507b9d0df8c8843 Mon Sep 17 00:00:00 2001 From: Stan Moore Date: Thu, 19 May 2022 10:35:10 -0600 Subject: [PATCH 169/585] Use c++11 variadic magic, suggested by @weinbe2 --- src/KOKKOS/memory_kokkos.h | 41 +++----------------------------------- 1 file changed, 3 insertions(+), 38 deletions(-) diff --git a/src/KOKKOS/memory_kokkos.h b/src/KOKKOS/memory_kokkos.h index 4d4d200745..b421bcc825 100644 --- a/src/KOKKOS/memory_kokkos.h +++ b/src/KOKKOS/memory_kokkos.h @@ -280,46 +280,11 @@ void destroy_kokkos(TYPE data, typename TYPE::value_type** &array) deallocate first to reduce memory use ------------------------------------------------------------------------- */ -template -static void realloc_kokkos(TYPE &data, const char *name, int n1) +template +static void realloc_kokkos(TYPE &data, const char *name, Indices... ns) { data = TYPE(); - data = TYPE(Kokkos::NoInit(std::string(name)),n1); -} - -template -static void realloc_kokkos(TYPE &data, const char *name, int n1, int n2) -{ - data = TYPE(); - data = TYPE(Kokkos::NoInit(std::string(name)),n1,n2); -} - -template -static void realloc_kokkos(TYPE &data, const char *name, int n1, int n2, int n3) -{ - data = TYPE(); - data = TYPE(Kokkos::NoInit(std::string(name)),n1,n2,n3); -} - -template -static void realloc_kokkos(TYPE &data, const char *name, int n1, int n2, int n3, int n4) -{ - data = TYPE(); - data = TYPE(Kokkos::NoInit(std::string(name)),n1,n2,n3,n4); -} - -template -static void realloc_kokkos(TYPE &data, const char *name, int n1, int n2, int n3, int n4, int n5) -{ - data = TYPE(); - data = TYPE(Kokkos::NoInit(std::string(name)),n1,n2,n3,n4,n5); -} - -template -static void realloc_kokkos(TYPE &data, const char *name, int n1, int n2, int n3, int n4, int n5, int n6) -{ - data = TYPE(); - data = TYPE(Kokkos::NoInit(std::string(name)),n1,n2,n3,n4,n5,n6); + data = TYPE(Kokkos::NoInit(std::string(name)), ns...); } /* ---------------------------------------------------------------------- From 872e4de6ab9c91cd8e1001457cc39f558e38e53e Mon Sep 17 00:00:00 2001 From: Lenz Fiedler Date: Thu, 19 May 2022 23:21:15 +0200 Subject: [PATCH 170/585] Rolled back the Modine transpose --- src/compute_grid_local.cpp | 8 ++++---- 1 file changed, 4 insertions(+), 4 deletions(-) diff --git a/src/compute_grid_local.cpp b/src/compute_grid_local.cpp index 0d8738e230..ec385f6a13 100644 --- a/src/compute_grid_local.cpp +++ b/src/compute_grid_local.cpp @@ -230,9 +230,9 @@ void ComputeGridLocal::set_grid_local() void ComputeGridLocal::assign_coords() { int igrid = 0; - for (int ix = nxlo; ix <= nxhi; ix++) + for (int iz = nzlo; iz <= nzhi; iz++) for (int iy = nylo; iy <= nyhi; iy++) - for (int iz = nzlo; iz <= nzhi; iz++) { + for (int ix = nxlo; ix <= nxhi; ix++) { alocal[igrid][0] = ix; alocal[igrid][1] = iy; alocal[igrid][2] = iz; @@ -260,9 +260,9 @@ void ComputeGridLocal::assign_coords() void ComputeGridLocal::copy_gridlocal_to_local_array() { int igrid = 0; - for (int ix = nxlo; ix <= nxhi; ix++) + for (int iz = nzlo; iz <= nzhi; iz++) for (int iy = nylo; iy <= nyhi; iy++) - for (int iz = nzlo; iz <= nzhi; iz++) { + for (int ix = nxlo; ix <= nxhi; ix++) { for (int icol = size_local_cols_base; icol < size_local_cols; icol++) alocal[igrid][icol] = gridlocal[icol][iz][iy][ix]; igrid++; From 4801fa00f8f19301c55687012dfe31d6a3abbb37 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 19 May 2022 22:53:48 -0400 Subject: [PATCH 171/585] update MathJax to latest bugfix release --- doc/Makefile | 3 ++- 1 file changed, 2 insertions(+), 1 deletion(-) diff --git a/doc/Makefile b/doc/Makefile index 113a64ec10..d63adc1ac4 100644 --- a/doc/Makefile +++ b/doc/Makefile @@ -13,6 +13,7 @@ VENV = $(BUILDDIR)/docenv ANCHORCHECK = $(VENV)/bin/rst_anchor_check SPHINXCONFIG = $(BUILDDIR)/utils/sphinx-config MATHJAX = $(SPHINXCONFIG)/_static/mathjax +MATHJAXTAG = 3.2.1 PYTHON = $(word 3,$(shell type python3)) DOXYGEN = $(word 3,$(shell type doxygen)) @@ -235,7 +236,7 @@ $(VENV): ) $(MATHJAX): - @git clone -b 3.2.0 -c advice.detachedHead=0 --depth 1 https://github.com/mathjax/MathJax.git $@ + @git clone -b $(MATHJAXTAG) -c advice.detachedHead=0 --depth 1 https://github.com/mathjax/MathJax.git $@ $(ANCHORCHECK): $(VENV) @( \ From 36d091baeb6acd94ae055f25fed7c7a67183453d Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 19 May 2022 23:06:54 -0400 Subject: [PATCH 172/585] fix underline --- doc/src/min_style.rst | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/doc/src/min_style.rst b/doc/src/min_style.rst index 2b1bb08c5f..eab43ed3ca 100644 --- a/doc/src/min_style.rst +++ b/doc/src/min_style.rst @@ -4,7 +4,7 @@ min_style cg command ==================== min_style hftn command -==================== +====================== min_style sd command ==================== From 13fc4f3588e86e7eca8e6410069434c3ade5f2b2 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 19 May 2022 23:07:12 -0400 Subject: [PATCH 173/585] must install wheel package before all other packages --- doc/Makefile | 1 + doc/utils/requirements.txt | 1 - 2 files changed, 1 insertion(+), 1 deletion(-) diff --git a/doc/Makefile b/doc/Makefile index d63adc1ac4..07b201b07e 100644 --- a/doc/Makefile +++ b/doc/Makefile @@ -231,6 +231,7 @@ $(VENV): $(PYTHON) -m venv $(VENV); \ . $(VENV)/bin/activate; \ pip $(PIP_OPTIONS) install --upgrade pip; \ + pip $(PIP_OPTIONS) install --upgrade wheel; \ pip $(PIP_OPTIONS) install -r $(BUILDDIR)/utils/requirements.txt; \ deactivate;\ ) diff --git a/doc/utils/requirements.txt b/doc/utils/requirements.txt index 9ff18b3652..1f5711dd6b 100644 --- a/doc/utils/requirements.txt +++ b/doc/utils/requirements.txt @@ -6,4 +6,3 @@ breathe Pygments six pyyaml -wheel From 07e93a643a1bb342aa2edf1fe9fd45317cd85999 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 19 May 2022 23:36:54 -0400 Subject: [PATCH 174/585] spelling --- doc/utils/sphinx-config/false_positives.txt | 3 +++ 1 file changed, 3 insertions(+) diff --git a/doc/utils/sphinx-config/false_positives.txt b/doc/utils/sphinx-config/false_positives.txt index c8450c570b..319d1b0a41 100644 --- a/doc/utils/sphinx-config/false_positives.txt +++ b/doc/utils/sphinx-config/false_positives.txt @@ -1319,6 +1319,7 @@ hexatic hexorder Heyes HfO +hftn hgrid hhmrr Hibbs @@ -2798,6 +2799,7 @@ quatk quatw queryargs Queteschiner +quickmin qw qx qy @@ -3051,6 +3053,7 @@ screenshot screenshots Scripps Scripta +sd sdk sdpd SDPD From bfb126ec7c44062e32b92d7cb41c5db5d829f9bf Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 19 May 2022 23:37:55 -0400 Subject: [PATCH 175/585] make neighbor list searches optionally check for the request ID --- src/neighbor.cpp | 12 ++++++------ src/neighbor.h | 8 ++++++-- 2 files changed, 12 insertions(+), 8 deletions(-) diff --git a/src/neighbor.cpp b/src/neighbor.cpp index 2c7ce0004b..432ac8206c 100644 --- a/src/neighbor.cpp +++ b/src/neighbor.cpp @@ -1742,15 +1742,15 @@ void Neighbor::requests_new2old() /* ---------------------------------------------------------------------- find and return request made by classptr if not found or classptr = nullptr, return nullptr - TODO: should have optional argument "id" to match ID if multiple requests + id is optional and defaults to 0, which is the request id value unless set explicitly ------------------------------------------------------------------------- */ -NeighRequest *Neighbor::find_request(void *classptr) const +NeighRequest *Neighbor::find_request(void *classptr, const int id) const { if (classptr == nullptr) return nullptr; for (int i = 0; i < nrequest; i++) - if (requests[i]->requestor == classptr) return requests[i]; + if ((requests[i]->requestor == classptr) && (requests[i]->id == id)) return requests[i]; return nullptr; } @@ -1770,15 +1770,15 @@ const std::vector Neighbor::get_pair_requests() const /* ---------------------------------------------------------------------- find and return list requested by classptr if not found or classptr = nullptr, return nullptr - TODO: should have optional argument "id" to match ID if multiple requests + id is optional and defaults to 0, which is the request id value unless set explicitly ------------------------------------------------------------------------- */ -NeighList *Neighbor::find_list(void *classptr) const +NeighList *Neighbor::find_list(void *classptr, const int id) const { if (classptr == nullptr) return nullptr; for (int i = 0; i < nlist; i++) - if (lists[i]->requestor == classptr) return lists[i]; + if ((requests[i]->requestor == classptr) && (requests[i]->id == id)) return lists[i]; return nullptr; } diff --git a/src/neighbor.h b/src/neighbor.h index 06601f96a7..3492693766 100644 --- a/src/neighbor.h +++ b/src/neighbor.h @@ -153,8 +153,12 @@ class Neighbor : protected Pointers { void exclusion_group_group_delete(int, int); // rm a group-group exclusion int exclude_setting(); // return exclude value to accelerator pkg - NeighList *find_list(void *) const; // find a neighbor list based on requestor - NeighRequest *find_request(void *) const; // find a neighbor request based on requestor + + // find a neighbor list based on requestor + NeighList *find_list(void *, const int id = 0) const; + // find a neighbor request based on requestor + NeighRequest *find_request(void *, const int id = 0) const; + const std::vector get_pair_requests() const; int any_full(); // Check if any old requests had full neighbor lists void build_collection(int); // build peratom collection array starting at the given index From 814daf7f4f89c7ff48e6d619f508d76f83b1a99a Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 20 May 2022 01:06:09 -0400 Subject: [PATCH 176/585] fix cut-n-paste error --- src/neighbor.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/neighbor.cpp b/src/neighbor.cpp index 432ac8206c..560392ae6d 100644 --- a/src/neighbor.cpp +++ b/src/neighbor.cpp @@ -1778,7 +1778,7 @@ NeighList *Neighbor::find_list(void *classptr, const int id) const if (classptr == nullptr) return nullptr; for (int i = 0; i < nlist; i++) - if ((requests[i]->requestor == classptr) && (requests[i]->id == id)) return lists[i]; + if ((lists[i]->requestor == classptr) && (lists[i]->id == id)) return lists[i]; return nullptr; } From 21c2f8a74b14aca9b7ba09171a837f9f1cdcd219 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 20 May 2022 01:06:21 -0400 Subject: [PATCH 177/585] fix miscalculated example --- doc/src/Howto_body.rst | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/doc/src/Howto_body.rst b/doc/src/Howto_body.rst index cc02e3d52f..88fa2d9c97 100644 --- a/doc/src/Howto_body.rst +++ b/doc/src/Howto_body.rst @@ -239,7 +239,7 @@ is consistent with the 6 moments of inertia: ixx iyy izz ixy ixz iyz = .. parsed-literal:: - 3 1 27 + 3 1 19 4 1 1 4 0 0 0 -0.7071 -0.7071 0 From a16974ca485015e2d9f76477398cf9addb09a8ce Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 20 May 2022 06:51:36 -0400 Subject: [PATCH 178/585] enable and apply clang-format --- src/pair_yukawa.cpp | 162 +++++++++++++++++++++----------------------- 1 file changed, 78 insertions(+), 84 deletions(-) diff --git a/src/pair_yukawa.cpp b/src/pair_yukawa.cpp index 620ca294c3..e1190b614f 100644 --- a/src/pair_yukawa.cpp +++ b/src/pair_yukawa.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -14,14 +13,14 @@ #include "pair_yukawa.h" -#include #include "atom.h" -#include "force.h" #include "comm.h" -#include "neigh_list.h" -#include "memory.h" #include "error.h" +#include "force.h" +#include "memory.h" +#include "neigh_list.h" +#include using namespace LAMMPS_NS; @@ -53,13 +52,13 @@ PairYukawa::~PairYukawa() void PairYukawa::compute(int eflag, int vflag) { - int i,j,ii,jj,inum,jnum,itype,jtype; - double xtmp,ytmp,ztmp,delx,dely,delz,evdwl,fpair; - double rsq,r2inv,r,rinv,screening,forceyukawa,factor; - int *ilist,*jlist,*numneigh,**firstneigh; + int i, j, ii, jj, inum, jnum, itype, jtype; + double xtmp, ytmp, ztmp, delx, dely, delz, evdwl, fpair; + double rsq, r2inv, r, rinv, screening, forceyukawa, factor; + int *ilist, *jlist, *numneigh, **firstneigh; evdwl = 0.0; - ev_init(eflag,vflag); + ev_init(eflag, vflag); double **x = atom->x; double **f = atom->f; @@ -92,25 +91,25 @@ void PairYukawa::compute(int eflag, int vflag) delx = xtmp - x[j][0]; dely = ytmp - x[j][1]; delz = ztmp - x[j][2]; - rsq = delx*delx + dely*dely + delz*delz; + rsq = delx * delx + dely * dely + delz * delz; jtype = type[j]; if (rsq < cutsq[itype][jtype]) { - r2inv = 1.0/rsq; + r2inv = 1.0 / rsq; r = sqrt(rsq); - rinv = 1.0/r; - screening = exp(-kappa*r); + rinv = 1.0 / r; + screening = exp(-kappa * r); forceyukawa = a[itype][jtype] * screening * (kappa + rinv); - fpair = factor*forceyukawa * r2inv; + fpair = factor * forceyukawa * r2inv; - f[i][0] += delx*fpair; - f[i][1] += dely*fpair; - f[i][2] += delz*fpair; + f[i][0] += delx * fpair; + f[i][1] += dely * fpair; + f[i][2] += delz * fpair; if (newton_pair || j < nlocal) { - f[j][0] -= delx*fpair; - f[j][1] -= dely*fpair; - f[j][2] -= delz*fpair; + f[j][0] -= delx * fpair; + f[j][1] -= dely * fpair; + f[j][2] -= delz * fpair; } if (eflag) { @@ -118,8 +117,7 @@ void PairYukawa::compute(int eflag, int vflag) evdwl *= factor; } - if (evflag) ev_tally(i,j,nlocal,newton_pair, - evdwl,0.0,fpair,delx,dely,delz); + if (evflag) ev_tally(i, j, nlocal, newton_pair, evdwl, 0.0, fpair, delx, dely, delz); } } } @@ -134,18 +132,17 @@ void PairYukawa::compute(int eflag, int vflag) void PairYukawa::allocate() { allocated = 1; - int n = atom->ntypes; + int np1 = atom->ntypes + 1; - memory->create(setflag,n+1,n+1,"pair:setflag"); - for (int i = 1; i <= n; i++) - for (int j = i; j <= n; j++) - setflag[i][j] = 0; + memory->create(setflag, np1, np1, "pair:setflag"); + for (int i = 1; i < np1; i++) + for (int j = i; j < np1; j++) setflag[i][j] = 0; - memory->create(cutsq,n+1,n+1,"pair:cutsq"); - memory->create(rad,n+1,"pair:rad"); - memory->create(cut,n+1,n+1,"pair:cut"); - memory->create(a,n+1,n+1,"pair:a"); - memory->create(offset,n+1,n+1,"pair:offset"); + memory->create(cutsq, np1, np1, "pair:cutsq"); + memory->create(rad, np1, "pair:rad"); + memory->create(cut, np1, np1, "pair:cut"); + memory->create(a, np1, np1, "pair:a"); + memory->create(offset, np1, np1, "pair:offset"); } /* ---------------------------------------------------------------------- @@ -154,15 +151,15 @@ void PairYukawa::allocate() void PairYukawa::settings(int narg, char **arg) { - if (narg != 2) error->all(FLERR,"Illegal pair_style command"); + if (narg != 2) error->all(FLERR, "Illegal pair_style command"); - kappa = utils::numeric(FLERR,arg[0],false,lmp); - cut_global = utils::numeric(FLERR,arg[1],false,lmp); + kappa = utils::numeric(FLERR, arg[0], false, lmp); + cut_global = utils::numeric(FLERR, arg[1], false, lmp); // reset cutoffs that have been explicitly set if (allocated) { - int i,j; + int i, j; for (i = 1; i <= atom->ntypes; i++) for (j = i; j <= atom->ntypes; j++) if (setflag[i][j]) cut[i][j] = cut_global; @@ -175,22 +172,21 @@ void PairYukawa::settings(int narg, char **arg) void PairYukawa::coeff(int narg, char **arg) { - if (narg < 3 || narg > 4) - error->all(FLERR,"Incorrect args for pair coefficients"); + if (narg < 3 || narg > 4) error->all(FLERR, "Incorrect args for pair coefficients"); if (!allocated) allocate(); - int ilo,ihi,jlo,jhi; - utils::bounds(FLERR,arg[0],1,atom->ntypes,ilo,ihi,error); - utils::bounds(FLERR,arg[1],1,atom->ntypes,jlo,jhi,error); + int ilo, ihi, jlo, jhi; + utils::bounds(FLERR, arg[0], 1, atom->ntypes, ilo, ihi, error); + utils::bounds(FLERR, arg[1], 1, atom->ntypes, jlo, jhi, error); - double a_one = utils::numeric(FLERR,arg[2],false,lmp); + double a_one = utils::numeric(FLERR, arg[2], false, lmp); double cut_one = cut_global; - if (narg == 4) cut_one = utils::numeric(FLERR,arg[3],false,lmp); + if (narg == 4) cut_one = utils::numeric(FLERR, arg[3], false, lmp); int count = 0; for (int i = ilo; i <= ihi; i++) { - for (int j = MAX(jlo,i); j <= jhi; j++) { + for (int j = MAX(jlo, i); j <= jhi; j++) { a[i][j] = a_one; cut[i][j] = cut_one; setflag[i][j] = 1; @@ -198,7 +194,7 @@ void PairYukawa::coeff(int narg, char **arg) } } - if (count == 0) error->all(FLERR,"Incorrect args for pair coefficients"); + if (count == 0) error->all(FLERR, "Incorrect args for pair coefficients"); } /* ---------------------------------------------------------------------- @@ -208,14 +204,15 @@ void PairYukawa::coeff(int narg, char **arg) double PairYukawa::init_one(int i, int j) { if (setflag[i][j] == 0) { - a[i][j] = mix_energy(a[i][i],a[j][j],1.0,1.0); - cut[i][j] = mix_distance(cut[i][i],cut[j][j]); + a[i][j] = mix_energy(a[i][i], a[j][j], 1.0, 1.0); + cut[i][j] = mix_distance(cut[i][i], cut[j][j]); } if (offset_flag && (cut[i][j] > 0.0)) { double screening = exp(-kappa * cut[i][j]); offset[i][j] = a[i][j] * screening / cut[i][j]; - } else offset[i][j] = 0.0; + } else + offset[i][j] = 0.0; a[j][i] = a[i][j]; offset[j][i] = offset[i][j]; @@ -231,13 +228,13 @@ void PairYukawa::write_restart(FILE *fp) { write_restart_settings(fp); - int i,j; + int i, j; for (i = 1; i <= atom->ntypes; i++) for (j = i; j <= atom->ntypes; j++) { - fwrite(&setflag[i][j],sizeof(int),1,fp); + fwrite(&setflag[i][j], sizeof(int), 1, fp); if (setflag[i][j]) { - fwrite(&a[i][j],sizeof(double),1,fp); - fwrite(&cut[i][j],sizeof(double),1,fp); + fwrite(&a[i][j], sizeof(double), 1, fp); + fwrite(&cut[i][j], sizeof(double), 1, fp); } } } @@ -252,19 +249,19 @@ void PairYukawa::read_restart(FILE *fp) allocate(); - int i,j; + int i, j; int me = comm->me; for (i = 1; i <= atom->ntypes; i++) for (j = i; j <= atom->ntypes; j++) { - if (me == 0) utils::sfread(FLERR,&setflag[i][j],sizeof(int),1,fp,nullptr,error); - MPI_Bcast(&setflag[i][j],1,MPI_INT,0,world); + if (me == 0) utils::sfread(FLERR, &setflag[i][j], sizeof(int), 1, fp, nullptr, error); + MPI_Bcast(&setflag[i][j], 1, MPI_INT, 0, world); if (setflag[i][j]) { if (me == 0) { - utils::sfread(FLERR,&a[i][j],sizeof(double),1,fp,nullptr,error); - utils::sfread(FLERR,&cut[i][j],sizeof(double),1,fp,nullptr,error); + utils::sfread(FLERR, &a[i][j], sizeof(double), 1, fp, nullptr, error); + utils::sfread(FLERR, &cut[i][j], sizeof(double), 1, fp, nullptr, error); } - MPI_Bcast(&a[i][j],1,MPI_DOUBLE,0,world); - MPI_Bcast(&cut[i][j],1,MPI_DOUBLE,0,world); + MPI_Bcast(&a[i][j], 1, MPI_DOUBLE, 0, world); + MPI_Bcast(&cut[i][j], 1, MPI_DOUBLE, 0, world); } } } @@ -275,10 +272,10 @@ void PairYukawa::read_restart(FILE *fp) void PairYukawa::write_restart_settings(FILE *fp) { - fwrite(&kappa,sizeof(double),1,fp); - fwrite(&cut_global,sizeof(double),1,fp); - fwrite(&offset_flag,sizeof(int),1,fp); - fwrite(&mix_flag,sizeof(int),1,fp); + fwrite(&kappa, sizeof(double), 1, fp); + fwrite(&cut_global, sizeof(double), 1, fp); + fwrite(&offset_flag, sizeof(int), 1, fp); + fwrite(&mix_flag, sizeof(int), 1, fp); } /* ---------------------------------------------------------------------- @@ -288,15 +285,15 @@ void PairYukawa::write_restart_settings(FILE *fp) void PairYukawa::read_restart_settings(FILE *fp) { if (comm->me == 0) { - utils::sfread(FLERR,&kappa,sizeof(double),1,fp,nullptr,error); - utils::sfread(FLERR,&cut_global,sizeof(double),1,fp,nullptr,error); - utils::sfread(FLERR,&offset_flag,sizeof(int),1,fp,nullptr,error); - utils::sfread(FLERR,&mix_flag,sizeof(int),1,fp,nullptr,error); + utils::sfread(FLERR, &kappa, sizeof(double), 1, fp, nullptr, error); + utils::sfread(FLERR, &cut_global, sizeof(double), 1, fp, nullptr, error); + utils::sfread(FLERR, &offset_flag, sizeof(int), 1, fp, nullptr, error); + utils::sfread(FLERR, &mix_flag, sizeof(int), 1, fp, nullptr, error); } - MPI_Bcast(&kappa,1,MPI_DOUBLE,0,world); - MPI_Bcast(&cut_global,1,MPI_DOUBLE,0,world); - MPI_Bcast(&offset_flag,1,MPI_INT,0,world); - MPI_Bcast(&mix_flag,1,MPI_INT,0,world); + MPI_Bcast(&kappa, 1, MPI_DOUBLE, 0, world); + MPI_Bcast(&cut_global, 1, MPI_DOUBLE, 0, world); + MPI_Bcast(&offset_flag, 1, MPI_INT, 0, world); + MPI_Bcast(&mix_flag, 1, MPI_INT, 0, world); } /* ---------------------------------------------------------------------- @@ -305,8 +302,7 @@ void PairYukawa::read_restart_settings(FILE *fp) void PairYukawa::write_data(FILE *fp) { - for (int i = 1; i <= atom->ntypes; i++) - fprintf(fp,"%d %g\n",i,a[i][i]); + for (int i = 1; i <= atom->ntypes; i++) fprintf(fp, "%d %g\n", i, a[i][i]); } /* ---------------------------------------------------------------------- @@ -316,25 +312,23 @@ void PairYukawa::write_data(FILE *fp) void PairYukawa::write_data_all(FILE *fp) { for (int i = 1; i <= atom->ntypes; i++) - for (int j = i; j <= atom->ntypes; j++) - fprintf(fp,"%d %d %g %g\n",i,j,a[i][j],cut[i][j]); + for (int j = i; j <= atom->ntypes; j++) fprintf(fp, "%d %d %g %g\n", i, j, a[i][j], cut[i][j]); } /* ---------------------------------------------------------------------- */ double PairYukawa::single(int /*i*/, int /*j*/, int itype, int jtype, double rsq, - double /*factor_coul*/, double factor_lj, - double &fforce) + double /*factor_coul*/, double factor_lj, double &fforce) { - double r2inv,r,rinv,screening,forceyukawa,phi; + double r2inv, r, rinv, screening, forceyukawa, phi; - r2inv = 1.0/rsq; + r2inv = 1.0 / rsq; r = sqrt(rsq); - rinv = 1.0/r; - screening = exp(-kappa*r); + rinv = 1.0 / r; + screening = exp(-kappa * r); forceyukawa = a[itype][jtype] * screening * (kappa + rinv); - fforce = factor_lj*forceyukawa * r2inv; + fforce = factor_lj * forceyukawa * r2inv; phi = a[itype][jtype] * screening * rinv - offset[itype][jtype]; - return factor_lj*phi; + return factor_lj * phi; } From 08b1034d54a4f9c6afef6b556bf342b0ce4e03fd Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 20 May 2022 07:12:25 -0400 Subject: [PATCH 179/585] enable and apply clang-format --- src/pair_zero.cpp | 111 +++++++++++++++++++++------------------------- 1 file changed, 50 insertions(+), 61 deletions(-) diff --git a/src/pair_zero.cpp b/src/pair_zero.cpp index 5c229d6b71..83505edd35 100644 --- a/src/pair_zero.cpp +++ b/src/pair_zero.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -20,8 +19,8 @@ #include "atom.h" #include "comm.h" -#include "memory.h" #include "error.h" +#include "memory.h" #include @@ -29,11 +28,12 @@ using namespace LAMMPS_NS; /* ---------------------------------------------------------------------- */ -PairZero::PairZero(LAMMPS *lmp) : Pair(lmp) { - coeffflag=1; - writedata=1; - single_enable=1; - respa_enable=1; +PairZero::PairZero(LAMMPS *lmp) : Pair(lmp) +{ + coeffflag = 1; + writedata = 1; + single_enable = 1; + respa_enable = 1; } /* ---------------------------------------------------------------------- */ @@ -51,15 +51,15 @@ PairZero::~PairZero() void PairZero::compute(int eflag, int vflag) { - ev_init(eflag,vflag); - if (vflag_fdotr) virial_fdotr_compute(); + ev_init(eflag, vflag); + if (vflag_fdotr) virial_fdotr_compute(); } /* ---------------------------------------------------------------------- */ void PairZero::compute_outer(int eflag, int vflag) { - ev_init(eflag,vflag); + ev_init(eflag, vflag); } /* ---------------------------------------------------------------------- @@ -69,15 +69,14 @@ void PairZero::compute_outer(int eflag, int vflag) void PairZero::allocate() { allocated = 1; - int n = atom->ntypes; + int np1 = atom->ntypes + 1; - memory->create(setflag,n+1,n+1,"pair:setflag"); - for (int i = 1; i <= n; i++) - for (int j = i; j <= n; j++) - setflag[i][j] = 0; + memory->create(setflag, np1, np1, "pair:setflag"); + for (int i = 1; i < np1; i++) + for (int j = i; j < np1; j++) setflag[i][j] = 0; - memory->create(cutsq,n+1,n+1,"pair:cutsq"); - memory->create(cut,n+1,n+1,"pair:cut"); + memory->create(cutsq, np1, np1, "pair:cutsq"); + memory->create(cut, np1, np1, "pair:cut"); } /* ---------------------------------------------------------------------- @@ -86,22 +85,22 @@ void PairZero::allocate() void PairZero::settings(int narg, char **arg) { - if ((narg != 1) && (narg != 2)) - error->all(FLERR,"Illegal pair_style command"); + if ((narg != 1) && (narg != 2)) error->all(FLERR, "Illegal pair_style command"); - cut_global = utils::numeric(FLERR,arg[0],false,lmp); + cut_global = utils::numeric(FLERR, arg[0], false, lmp); if (narg == 2) { - if (strcmp("nocoeff",arg[1]) == 0) coeffflag=0; - else error->all(FLERR,"Illegal pair_style command"); + if (strcmp("nocoeff", arg[1]) == 0) + coeffflag = 0; + else + error->all(FLERR, "Illegal pair_style command"); } // reset cutoffs that have been explicitly set if (allocated) { - int i,j; + int i, j; for (i = 1; i <= atom->ntypes; i++) - for (j = i+1; j <= atom->ntypes; j++) - cut[i][j] = cut_global; + for (j = i + 1; j <= atom->ntypes; j++) cut[i][j] = cut_global; } } @@ -112,27 +111,27 @@ void PairZero::settings(int narg, char **arg) void PairZero::coeff(int narg, char **arg) { if ((narg < 2) || (coeffflag && narg > 3)) - error->all(FLERR,"Incorrect args for pair coefficients"); + error->all(FLERR, "Incorrect args for pair coefficients"); if (!allocated) allocate(); - int ilo,ihi,jlo,jhi; - utils::bounds(FLERR,arg[0],1,atom->ntypes,ilo,ihi,error); - utils::bounds(FLERR,arg[1],1,atom->ntypes,jlo,jhi,error); + int ilo, ihi, jlo, jhi; + utils::bounds(FLERR, arg[0], 1, atom->ntypes, ilo, ihi, error); + utils::bounds(FLERR, arg[1], 1, atom->ntypes, jlo, jhi, error); double cut_one = cut_global; - if (coeffflag && (narg == 3)) cut_one = utils::numeric(FLERR,arg[2],false,lmp); + if (coeffflag && (narg == 3)) cut_one = utils::numeric(FLERR, arg[2], false, lmp); int count = 0; for (int i = ilo; i <= ihi; i++) { - for (int j = MAX(jlo,i); j <= jhi; j++) { + for (int j = MAX(jlo, i); j <= jhi; j++) { cut[i][j] = cut_one; setflag[i][j] = 1; count++; } } - if (count == 0) error->all(FLERR,"Incorrect args for pair coefficients"); + if (count == 0) error->all(FLERR, "Incorrect args for pair coefficients"); } /* ---------------------------------------------------------------------- @@ -141,9 +140,7 @@ void PairZero::coeff(int narg, char **arg) double PairZero::init_one(int i, int j) { - if (setflag[i][j] == 0) { - cut[i][j] = mix_distance(cut[i][i],cut[j][j]); - } + if (setflag[i][j] == 0) { cut[i][j] = mix_distance(cut[i][i], cut[j][j]); } return cut[i][j]; } @@ -156,13 +153,11 @@ void PairZero::write_restart(FILE *fp) { write_restart_settings(fp); - int i,j; + int i, j; for (i = 1; i <= atom->ntypes; i++) for (j = i; j <= atom->ntypes; j++) { - fwrite(&setflag[i][j],sizeof(int),1,fp); - if (setflag[i][j]) { - fwrite(&cut[i][j],sizeof(double),1,fp); - } + fwrite(&setflag[i][j], sizeof(int), 1, fp); + if (setflag[i][j]) { fwrite(&cut[i][j], sizeof(double), 1, fp); } } } @@ -175,17 +170,15 @@ void PairZero::read_restart(FILE *fp) read_restart_settings(fp); allocate(); - int i,j; + int i, j; int me = comm->me; for (i = 1; i <= atom->ntypes; i++) for (j = i; j <= atom->ntypes; j++) { - if (me == 0) utils::sfread(FLERR,&setflag[i][j],sizeof(int),1,fp,nullptr,error); - MPI_Bcast(&setflag[i][j],1,MPI_INT,0,world); + if (me == 0) utils::sfread(FLERR, &setflag[i][j], sizeof(int), 1, fp, nullptr, error); + MPI_Bcast(&setflag[i][j], 1, MPI_INT, 0, world); if (setflag[i][j]) { - if (me == 0) { - utils::sfread(FLERR,&cut[i][j],sizeof(double),1,fp,nullptr,error); - } - MPI_Bcast(&cut[i][j],1,MPI_DOUBLE,0,world); + if (me == 0) { utils::sfread(FLERR, &cut[i][j], sizeof(double), 1, fp, nullptr, error); } + MPI_Bcast(&cut[i][j], 1, MPI_DOUBLE, 0, world); } } } @@ -196,8 +189,8 @@ void PairZero::read_restart(FILE *fp) void PairZero::write_restart_settings(FILE *fp) { - fwrite(&cut_global,sizeof(double),1,fp); - fwrite(&coeffflag,sizeof(int),1,fp); + fwrite(&cut_global, sizeof(double), 1, fp); + fwrite(&coeffflag, sizeof(int), 1, fp); } /* ---------------------------------------------------------------------- @@ -208,11 +201,11 @@ void PairZero::read_restart_settings(FILE *fp) { int me = comm->me; if (me == 0) { - utils::sfread(FLERR,&cut_global,sizeof(double),1,fp,nullptr,error); - utils::sfread(FLERR,&coeffflag,sizeof(int),1,fp,nullptr,error); + utils::sfread(FLERR, &cut_global, sizeof(double), 1, fp, nullptr, error); + utils::sfread(FLERR, &coeffflag, sizeof(int), 1, fp, nullptr, error); } - MPI_Bcast(&cut_global,1,MPI_DOUBLE,0,world); - MPI_Bcast(&coeffflag,1,MPI_INT,0,world); + MPI_Bcast(&cut_global, 1, MPI_DOUBLE, 0, world); + MPI_Bcast(&coeffflag, 1, MPI_INT, 0, world); } /* ---------------------------------------------------------------------- @@ -221,8 +214,7 @@ void PairZero::read_restart_settings(FILE *fp) void PairZero::write_data(FILE *fp) { - for (int i = 1; i <= atom->ntypes; i++) - fprintf(fp,"%d\n",i); + for (int i = 1; i <= atom->ntypes; i++) fprintf(fp, "%d\n", i); } /* ---------------------------------------------------------------------- @@ -232,17 +224,14 @@ void PairZero::write_data(FILE *fp) void PairZero::write_data_all(FILE *fp) { for (int i = 1; i <= atom->ntypes; i++) - for (int j = i; j <= atom->ntypes; j++) - fprintf(fp,"%d %d %g\n",i,j,cut[i][j]); + for (int j = i; j <= atom->ntypes; j++) fprintf(fp, "%d %d %g\n", i, j, cut[i][j]); } /* ---------------------------------------------------------------------- */ -double PairZero::single(int /*i*/, int /*j*/, int /* itype */, int /* jtype */, - double /* rsq */, double /*factor_coul*/, - double /* factor_lj */, double &fforce) +double PairZero::single(int /*i*/, int /*j*/, int /* itype */, int /* jtype */, double /* rsq */, + double /*factor_coul*/, double /* factor_lj */, double &fforce) { fforce = 0.0; return 0.0; } - From 7eb926c853a242a538f5d1a98b588f6b5e9d006f Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 20 May 2022 07:14:05 -0400 Subject: [PATCH 180/585] clarify the description of pair style none explain that pair style none is effectively deleting any existing pair style and that communication and neighbor list cutoff are affected. update those explanations for changes to LAMMPS that allow adjusting those not just with the neighbor list skin. Also add that pair_coeff must not be used. --- doc/src/pair_none.rst | 41 +++++++++++++++++++++++++---------------- 1 file changed, 25 insertions(+), 16 deletions(-) diff --git a/doc/src/pair_none.rst b/doc/src/pair_none.rst index 3dc87a7815..0bb366bce1 100644 --- a/doc/src/pair_none.rst +++ b/doc/src/pair_none.rst @@ -20,28 +20,37 @@ Examples Description """"""""""" -Using a pair style of none means pair forces and energies are not -computed. +Using a pair style of *none* means that any previous pair style setting +will be deleted and pairwise forces and energies are not computed. -With this choice, the force cutoff is 0.0, which means that only atoms -within the neighbor skin distance (see the :doc:`neighbor ` -command) are communicated between processors. You must insure the -skin distance is large enough to acquire atoms needed for computing -bonds, angles, etc. +As a consequence there will be a pairwise force cutoff of 0.0, which has +implications for the default setting of the neighbor list and the +communication cutoff. Those are the sum of the largest pairwise cutoff +and the neighbor skin distance (see the documentation of the +:doc:`neighbor ` command and the :doc:`comm_modify +` command). When you have bonds, angles, dihedrals, or +impropers defined at the same time, you must set the communication +cutoff so that communication cutoff distance is large enough to acquire +and communicate sufficient ghost atoms from neighboring sub-domains as +needed for computing bonds, angles, etc. -A pair style of *none* will also prevent pairwise neighbor lists from -being built. However if the :doc:`neighbor ` style is *bin*, -data structures for binning are still allocated. If the neighbor skin -distance is small, then these data structures can consume a large -amount of memory. So you should either set the neighbor style to -*nsq* or set the skin distance to a larger value. +A pair style of *none* will also not request a pairwise neighbor list. +However if the :doc:`neighbor ` style is *bin*, data +structures for binning are still allocated. If the neighbor list cutoff +is small, then these data structures can consume a large amount of +memory. So you should either set the neighbor style to *nsq* or set the +skin distance to a larger value. -See the :doc:`pair_style zero ` for a way to trigger the -building of a neighbor lists, but compute no pairwise interactions. +See the :doc:`pair_style zero ` for a way to set a pairwise +cutoff and thus trigger the building of a neighbor lists and setting +a corresponding communication cutoff, but compute no pairwise interactions. Restrictions """""""""""" -none + +You must not use a :doc:`pair_coeff ` command with this pair +style. Since there is no interaction computed, you cannot set any +coefficients for it. Related commands """""""""""""""" From 2c5ce83d59fe5c8da4c87feedd074cf5d48147fe Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 20 May 2022 09:27:16 -0400 Subject: [PATCH 181/585] must set Output::next_dump_any to current step with rerun --- src/rerun.cpp | 1 + 1 file changed, 1 insertion(+) diff --git a/src/rerun.cpp b/src/rerun.cpp index b788cfcaec..f0048a3ce2 100644 --- a/src/rerun.cpp +++ b/src/rerun.cpp @@ -165,6 +165,7 @@ void Rerun::command(int narg, char **arg) modify->init(); update->integrate->setup_minimal(1); modify->end_of_step(); + output->next_dump_any = ntimestep; if (firstflag) output->setup(); else if (output->next) output->write(ntimestep); From 2b001f9505aff2fe538d78c42720960025b412df Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Fri, 20 May 2022 13:21:55 -0600 Subject: [PATCH 182/585] Fix subdomain check for triclinic --- src/compute_grid_local.cpp | 7 +++++-- 1 file changed, 5 insertions(+), 2 deletions(-) diff --git a/src/compute_grid_local.cpp b/src/compute_grid_local.cpp index ec385f6a13..66eb0c5db3 100644 --- a/src/compute_grid_local.cpp +++ b/src/compute_grid_local.cpp @@ -81,6 +81,7 @@ void ComputeGridLocal::setup() /* ---------------------------------------------------------------------- convert global array indexes to box coords + for triclinic, these will be lamda coords ------------------------------------------------------------------------- */ void ComputeGridLocal::grid2x(int ix, int iy, int iz, double *x) @@ -88,8 +89,6 @@ void ComputeGridLocal::grid2x(int ix, int iy, int iz, double *x) x[0] = ix*delx; x[1] = iy*dely; x[2] = iz*delz; - - if (triclinic) domain->lamda2x(x, x); } /* ---------------------------------------------------------------------- @@ -245,6 +244,10 @@ void ComputeGridLocal::assign_coords() xgrid[1] < sublo[1] || xgrid[1] > subhi[1] || xgrid[2] < sublo[2] || xgrid[2] > subhi[2]) error->one(FLERR,"Invalid gridpoint position in compute grid/local"); + + // convert lamda to x, y, z, after sudomain check + + if (triclinic) domain->lamda2x(xgrid, xgrid); alocal[igrid][3] = xgrid[0]; alocal[igrid][4] = xgrid[1]; From c3ce77bc8c4aec79e36b7b8dd76a31f885e0dff2 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 20 May 2022 16:33:46 -0400 Subject: [PATCH 183/585] improve energy scaling sanity checks --- src/RIGID/fix_ehex.cpp | 11 ++++++++--- 1 file changed, 8 insertions(+), 3 deletions(-) diff --git a/src/RIGID/fix_ehex.cpp b/src/RIGID/fix_ehex.cpp index 1962578691..6bbd1b7424 100644 --- a/src/RIGID/fix_ehex.cpp +++ b/src/RIGID/fix_ehex.cpp @@ -253,9 +253,10 @@ void FixEHEX::rescale() escale = 1. + (F * dt) / Kr; - // safety check for kinetic energy + // safety checks for kinetic energy rescaling - if (escale < 0.0) error->all(FLERR, "Fix ehex kinetic energy went negative"); + if (escale < 0.0) error->all(FLERR, "Fix ehex kinetic energy went negative: {}", escale); + if (escale > 100.0) error->all(FLERR, "Fix ehex kinetic energy rescaling too large: {}", escale); scale = sqrt(escale); vsub[0] = (scale - 1.0) * vcm[0]; @@ -569,7 +570,11 @@ void FixEHEX::com_properties(double *vr, double *sfr, double *sfvr, double *K, d *mr = buf[4]; - if (*mr < 1.e-14) { error->all(FLERR, "Fix ehex error mass of region is close to zero"); } + if (nlocal > 0) + mi = (rmass) ? rmass[0] : mass[type[0]]; + else + mi = 1.0; + if ((*mr / mi) < 1.e-14) error->all(FLERR, "Fix ehex error mass of region is close to zero"); // total kinetic energy of region From e3e849b266ec555f9c81d5c1454f36761957a396 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sat, 21 May 2022 07:37:25 -0400 Subject: [PATCH 184/585] skip compressed file format tests if gzip executable is not found --- unittest/formats/CMakeLists.txt | 5 ++--- 1 file changed, 2 insertions(+), 3 deletions(-) diff --git a/unittest/formats/CMakeLists.txt b/unittest/formats/CMakeLists.txt index 8a198d4c64..5122dd7ca3 100644 --- a/unittest/formats/CMakeLists.txt +++ b/unittest/formats/CMakeLists.txt @@ -46,9 +46,8 @@ target_link_libraries(test_dump_atom PRIVATE lammps GTest::GMock) add_test(NAME DumpAtom COMMAND test_dump_atom) set_tests_properties(DumpAtom PROPERTIES ENVIRONMENT "LAMMPS_POTENTIALS=${LAMMPS_POTENTIALS_DIR}") -if(PKG_COMPRESS) - find_program(GZIP_BINARY NAMES gzip REQUIRED) - +find_program(GZIP_EXECUTABLE NAMES gzip) +if(PKG_COMPRESS AND GZIP_FOUND) add_executable(test_dump_atom_compressed test_dump_atom_compressed.cpp compressed_dump_test_main.cpp) target_link_libraries(test_dump_atom_compressed PRIVATE lammps GTest::GMock) From 007588f9cbf4410684ecf71cf348bd0dc0025a82 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sat, 21 May 2022 18:56:58 -0400 Subject: [PATCH 185/585] use GZIP executable variable name consistently --- unittest/formats/CMakeLists.txt | 10 +++++----- 1 file changed, 5 insertions(+), 5 deletions(-) diff --git a/unittest/formats/CMakeLists.txt b/unittest/formats/CMakeLists.txt index 5122dd7ca3..f1408de4d7 100644 --- a/unittest/formats/CMakeLists.txt +++ b/unittest/formats/CMakeLists.txt @@ -64,19 +64,19 @@ if(PKG_COMPRESS AND GZIP_FOUND) target_link_libraries(test_dump_xyz_compressed PRIVATE lammps GTest::GMock) add_test(NAME DumpAtomGZ COMMAND test_dump_atom_compressed gz) - set_tests_properties(DumpAtomGZ PROPERTIES ENVIRONMENT "LAMMPS_POTENTIALS=${LAMMPS_POTENTIALS_DIR};COMPRESS_BINARY=${GZIP_BINARY}") + set_tests_properties(DumpAtomGZ PROPERTIES ENVIRONMENT "LAMMPS_POTENTIALS=${LAMMPS_POTENTIALS_DIR};COMPRESS_BINARY=${GZIP_EXECUTABLE}") add_test(NAME DumpCustomGZ COMMAND test_dump_custom_compressed gz) - set_tests_properties(DumpCustomGZ PROPERTIES ENVIRONMENT "LAMMPS_POTENTIALS=${LAMMPS_POTENTIALS_DIR};COMPRESS_BINARY=${GZIP_BINARY}") + set_tests_properties(DumpCustomGZ PROPERTIES ENVIRONMENT "LAMMPS_POTENTIALS=${LAMMPS_POTENTIALS_DIR};COMPRESS_BINARY=${GZIP_EXECUTABLE}") add_test(NAME DumpCfgGZ COMMAND test_dump_cfg_compressed gz) - set_tests_properties(DumpCfgGZ PROPERTIES ENVIRONMENT "LAMMPS_POTENTIALS=${LAMMPS_POTENTIALS_DIR};COMPRESS_BINARY=${GZIP_BINARY}") + set_tests_properties(DumpCfgGZ PROPERTIES ENVIRONMENT "LAMMPS_POTENTIALS=${LAMMPS_POTENTIALS_DIR};COMPRESS_BINARY=${GZIP_EXECUTABLE}") add_test(NAME DumpLocalGZ COMMAND test_dump_local_compressed gz) - set_tests_properties(DumpLocalGZ PROPERTIES ENVIRONMENT "LAMMPS_POTENTIALS=${LAMMPS_POTENTIALS_DIR};COMPRESS_BINARY=${GZIP_BINARY}") + set_tests_properties(DumpLocalGZ PROPERTIES ENVIRONMENT "LAMMPS_POTENTIALS=${LAMMPS_POTENTIALS_DIR};COMPRESS_BINARY=${GZIP_EXECUTABLE}") add_test(NAME DumpXYZGZ COMMAND test_dump_xyz_compressed gz) - set_tests_properties(DumpXYZGZ PROPERTIES ENVIRONMENT "LAMMPS_POTENTIALS=${LAMMPS_POTENTIALS_DIR};COMPRESS_BINARY=${GZIP_BINARY}") + set_tests_properties(DumpXYZGZ PROPERTIES ENVIRONMENT "LAMMPS_POTENTIALS=${LAMMPS_POTENTIALS_DIR};COMPRESS_BINARY=${GZIP_EXECUTABLE}") find_package(PkgConfig REQUIRED) pkg_check_modules(Zstd IMPORTED_TARGET libzstd>=1.4) From 93692ce308fa822cabfb77ffed7205b3097a9442 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sat, 21 May 2022 23:33:13 -0400 Subject: [PATCH 186/585] Improved Windows and Visual Studio version detection This now uses the CurrentBuild key to detect the Windows version and only falls back to product name, if that fails. This is needed because Windows 11 reports itself as Windows 10 in the product name key. --- src/platform.cpp | 63 +++++++++++++++++++++++++++++++++++++++++++----- 1 file changed, 57 insertions(+), 6 deletions(-) diff --git a/src/platform.cpp b/src/platform.cpp index 907b4ef677..932b38f48c 100644 --- a/src/platform.cpp +++ b/src/platform.cpp @@ -186,13 +186,57 @@ std::string platform::os_info() char value[1024]; DWORD value_length = 1024; const char *subkey = "SOFTWARE\\Microsoft\\Windows NT\\CurrentVersion"; - const char *entry = "ProductName"; + const char *entry = "CurrentBuild"; RegGetValue(HKEY_LOCAL_MACHINE, subkey, entry, RRF_RT_REG_SZ, nullptr, &value, (LPDWORD) &value_length); // enforce zero termination value[1023] = '\0'; - buf = value; - + auto build = std::string(value); + + if (build == "6002") { + buf = "Windows Vista"; + } else if (build == "7601") { + buf = "Windows 7"; + } else if (build == "9200") { + buf = "Windows 8"; + } else if (build == "9600") { + buf = "Windows 8.1"; + } else if (build == "10240") { + buf = "Windows 10 1507"; + } else if (build == "10586") { + buf = "Windows 10 1511"; + } else if (build == "14393") { + buf = "Windows 10 1607"; + } else if (build == "15063") { + buf = "Windows 10 1703"; + } else if (build == "16299") { + buf = "Windows 10 1709"; + } else if (build == "17134") { + buf = "Windows 10 1803"; + } else if (build == "17763") { + buf = "Windows 10 1809"; + } else if (build == "18362") { + buf = "Windows 10 1903"; + } else if (build == "18363") { + buf = "Windows 10 1909"; + } else if (build == "19041") { + buf = "Windows 10 2004"; + } else if (build == "19042") { + buf = "Windows 10 20H2"; + } else if (build == "19043") { + buf = "Windows 10 21H1"; + } else if (build == "19044") { + buf = "Windows 10 21H2"; + } else if (build == "22000") { + buf = "Windows 11 21H2"; + } else { + const char *entry = "ProductName"; + RegGetValue(HKEY_LOCAL_MACHINE, subkey, entry, RRF_RT_REG_SZ, nullptr, &value, + (LPDWORD) &value_length); + // enforce zero termination + value[1023] = '\0'; + buf = value; + } DWORD fullversion, majorv, minorv, buildv = 0; fullversion = GetVersion(); majorv = (DWORD) (LOBYTE(LOWORD(fullversion))); @@ -303,11 +347,18 @@ std::string platform::compiler_info() __MINGW32_MINOR_VERSION, __VERSION__); #elif defined(__GNUC__) buf = fmt::format("GNU C++ {}", __VERSION__); -#elif defined(_MSC_VER) && (_MSC_VER > 1920) && (_MSC_VER < 2000) +#elif defined(_MSC_VER) && (_MSC_VER >= 1920) && (_MSC_VER < 1930) constexpr int major = _MSC_VER / 100; constexpr int minor = _MSC_VER - major * 100; - buf = "Microsoft Visual Studio 20" + std::to_string(major) + ", C/C++ " + - std::to_string(major - 5) + "." + std::to_string(minor); + constexpr int patch = minor - 20; + buf = fmt::format("Microsoft Visual Studio 2019 Version 16.{}, C/C++ {}.{}", patch, major - 5, + minor); +#elif defined(_MSC_VER) && (_MSC_VER >= 1930) && (_MSC_VER < 2000) + constexpr int major = _MSC_VER / 100; + constexpr int minor = _MSC_VER - major * 100; + constexpr int patch = minor - 30; + buf = fmt::format("Microsoft Visual Studio 2022 Version 17.{}, C/C++ {}.{}", patch, major - 5, + minor); #else buf = "(Unknown)"; #endif From b407b2f23963f8022f22bf90224600b9a8c6d49a Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sat, 21 May 2022 23:35:47 -0400 Subject: [PATCH 187/585] apply clang-format --- src/platform.cpp | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/src/platform.cpp b/src/platform.cpp index 932b38f48c..5e396d3f63 100644 --- a/src/platform.cpp +++ b/src/platform.cpp @@ -192,9 +192,9 @@ std::string platform::os_info() // enforce zero termination value[1023] = '\0'; auto build = std::string(value); - + if (build == "6002") { - buf = "Windows Vista"; + buf = "Windows Vista"; } else if (build == "7601") { buf = "Windows 7"; } else if (build == "9200") { From 9a973e67fa22298874321a5beb8721fa39adccd3 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sun, 22 May 2022 03:29:33 -0400 Subject: [PATCH 188/585] enable and apply clang-format --- src/angle_deprecated.cpp | 12 +-- src/body.cpp | 3 +- src/bond_deprecated.cpp | 10 +-- src/compute_angle.cpp | 29 +++--- src/compute_bond.cpp | 30 +++---- src/compute_com.cpp | 14 ++- src/compute_deprecated.cpp | 8 +- src/compute_erotate_sphere.cpp | 17 ++-- src/compute_ke.cpp | 17 ++-- src/compute_stress_atom.cpp | 159 ++++++++++++++++----------------- src/dihedral_deprecated.cpp | 8 +- src/dump_deprecated.cpp | 9 +- src/fix_deprecated.cpp | 23 +++-- src/fix_nph.cpp | 14 ++- src/fix_nph_sphere.cpp | 14 ++- src/fix_npt.cpp | 14 ++- src/fix_npt_sphere.cpp | 14 ++- src/fix_nvt.cpp | 12 +-- src/improper_deprecated.cpp | 1 - src/kspace_deprecated.cpp | 10 +-- src/minimize.cpp | 19 ++-- src/pair_deprecated.cpp | 16 ++-- src/region_deprecated.cpp | 10 +-- 23 files changed, 196 insertions(+), 267 deletions(-) diff --git a/src/angle_deprecated.cpp b/src/angle_deprecated.cpp index 55e1651b94..60cdab3398 100644 --- a/src/angle_deprecated.cpp +++ b/src/angle_deprecated.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -19,8 +18,8 @@ #include "angle_deprecated.h" #include "angle_hybrid.h" #include "comm.h" -#include "force.h" #include "error.h" +#include "force.h" using namespace LAMMPS_NS; @@ -33,17 +32,14 @@ void AngleDeprecated::settings(int, char **) // hybrid substyles are created in AngleHybrid::settings(), so when this is // called, our style was just added at the end of the list of substyles - if (utils::strmatch(my_style,"^hybrid")) { + if (utils::strmatch(my_style, "^hybrid")) { auto hybrid = dynamic_cast(force->angle); my_style = hybrid->keywords[hybrid->nstyles]; } if (my_style == "DEPRECATED") { - if (lmp->comm->me == 0) - utils::logmesg(lmp,"\nAngle style 'DEPRECATED' is a dummy style\n\n"); + if (lmp->comm->me == 0) utils::logmesg(lmp, "\nAngle style 'DEPRECATED' is a dummy style\n\n"); return; } - error->all(FLERR,"This angle style is no longer available"); + error->all(FLERR, "This angle style is no longer available"); } - - diff --git a/src/body.cpp b/src/body.cpp index 51b2672040..f59acdfc66 100644 --- a/src/body.cpp +++ b/src/body.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -29,5 +28,5 @@ Body::Body(LAMMPS *lmp, int /*narg*/, char **arg) : Pointers(lmp) Body::~Body() { - delete [] style; + delete[] style; } diff --git a/src/bond_deprecated.cpp b/src/bond_deprecated.cpp index 98bf6ea9ae..6d4c17b5d0 100644 --- a/src/bond_deprecated.cpp +++ b/src/bond_deprecated.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -34,17 +33,14 @@ void BondDeprecated::settings(int, char **) // hybrid substyles are created in BondHybrid::settings(), so when this is // called, our style was just added at the end of the list of substyles - if (utils::strmatch(my_style,"^hybrid")) { + if (utils::strmatch(my_style, "^hybrid")) { auto hybrid = dynamic_cast(force->bond); my_style = hybrid->keywords[hybrid->nstyles]; } if (my_style == "DEPRECATED") { - if (lmp->comm->me == 0) - utils::logmesg(lmp,"\nBond style 'DEPRECATED' is a dummy style\n\n"); + if (lmp->comm->me == 0) utils::logmesg(lmp, "\nBond style 'DEPRECATED' is a dummy style\n\n"); return; } - error->all(FLERR,"This bond style is no longer available"); + error->all(FLERR, "This bond style is no longer available"); } - - diff --git a/src/compute_angle.cpp b/src/compute_angle.cpp index e4db464f28..bf1241754d 100644 --- a/src/compute_angle.cpp +++ b/src/compute_angle.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -25,10 +24,9 @@ using namespace LAMMPS_NS; /* ---------------------------------------------------------------------- */ ComputeAngle::ComputeAngle(LAMMPS *lmp, int narg, char **arg) : - Compute(lmp, narg, arg), - emine(nullptr) + Compute(lmp, narg, arg), emine(nullptr) { - if (narg != 3) error->all(FLERR,"Illegal compute angle command"); + if (narg != 3) error->all(FLERR, "Illegal compute angle command"); vector_flag = 1; extvector = 1; @@ -37,9 +35,8 @@ ComputeAngle::ComputeAngle(LAMMPS *lmp, int narg, char **arg) : // check if bond style hybrid exists - angle = dynamic_cast( force->angle_match("hybrid")); - if (!angle) - error->all(FLERR,"Angle style for compute angle command is not hybrid"); + angle = dynamic_cast(force->angle_match("hybrid")); + if (!angle) error->all(FLERR, "Angle style for compute angle command is not hybrid"); size_vector = nsub = angle->nstyles; emine = new double[nsub]; @@ -50,8 +47,8 @@ ComputeAngle::ComputeAngle(LAMMPS *lmp, int narg, char **arg) : ComputeAngle::~ComputeAngle() { - delete [] emine; - delete [] vector; + delete[] emine; + delete[] vector; } /* ---------------------------------------------------------------------- */ @@ -60,11 +57,10 @@ void ComputeAngle::init() { // recheck angle style in case it has been changed - angle = dynamic_cast( force->angle_match("hybrid")); - if (!angle) - error->all(FLERR,"Angle style for compute angle command is not hybrid"); + angle = dynamic_cast(force->angle_match("hybrid")); + if (!angle) error->all(FLERR, "Angle style for compute angle command is not hybrid"); if (angle->nstyles != nsub) - error->all(FLERR,"Angle style for compute angle command has changed"); + error->all(FLERR, "Angle style for compute angle command has changed"); } /* ---------------------------------------------------------------------- */ @@ -73,10 +69,9 @@ void ComputeAngle::compute_vector() { invoked_vector = update->ntimestep; if (update->eflag_global != invoked_vector) - error->all(FLERR,"Energy was not tallied on needed timestep"); + error->all(FLERR, "Energy was not tallied on needed timestep"); - for (int i = 0; i < nsub; i++) - emine[i] = angle->styles[i]->energy; + for (int i = 0; i < nsub; i++) emine[i] = angle->styles[i]->energy; - MPI_Allreduce(emine,vector,nsub,MPI_DOUBLE,MPI_SUM,world); + MPI_Allreduce(emine, vector, nsub, MPI_DOUBLE, MPI_SUM, world); } diff --git a/src/compute_bond.cpp b/src/compute_bond.cpp index 38f15211e0..c0d65c55d5 100644 --- a/src/compute_bond.cpp +++ b/src/compute_bond.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -25,10 +24,9 @@ using namespace LAMMPS_NS; /* ---------------------------------------------------------------------- */ ComputeBond::ComputeBond(LAMMPS *lmp, int narg, char **arg) : - Compute(lmp, narg, arg), - emine(nullptr) + Compute(lmp, narg, arg), emine(nullptr) { - if (narg != 3) error->all(FLERR,"Illegal compute bond command"); + if (narg != 3) error->all(FLERR, "Illegal compute bond command"); vector_flag = 1; extvector = 1; @@ -37,9 +35,8 @@ ComputeBond::ComputeBond(LAMMPS *lmp, int narg, char **arg) : // check if bond style hybrid exists - bond = dynamic_cast( force->bond_match("hybrid")); - if (!bond) - error->all(FLERR,"Bond style for compute bond command is not hybrid"); + bond = dynamic_cast(force->bond_match("hybrid")); + if (!bond) error->all(FLERR, "Bond style for compute bond command is not hybrid"); size_vector = nsub = bond->nstyles; emine = new double[nsub]; @@ -50,8 +47,8 @@ ComputeBond::ComputeBond(LAMMPS *lmp, int narg, char **arg) : ComputeBond::~ComputeBond() { - delete [] emine; - delete [] vector; + delete[] emine; + delete[] vector; } /* ---------------------------------------------------------------------- */ @@ -60,11 +57,9 @@ void ComputeBond::init() { // recheck bond style in case it has been changed - bond = dynamic_cast( force->bond_match("hybrid")); - if (!bond) - error->all(FLERR,"Bond style for compute bond command is not hybrid"); - if (bond->nstyles != nsub) - error->all(FLERR,"Bond style for compute bond command has changed"); + bond = dynamic_cast(force->bond_match("hybrid")); + if (!bond) error->all(FLERR, "Bond style for compute bond command is not hybrid"); + if (bond->nstyles != nsub) error->all(FLERR, "Bond style for compute bond command has changed"); } /* ---------------------------------------------------------------------- */ @@ -73,10 +68,9 @@ void ComputeBond::compute_vector() { invoked_vector = update->ntimestep; if (update->eflag_global != invoked_vector) - error->all(FLERR,"Energy was not tallied on needed timestep"); + error->all(FLERR, "Energy was not tallied on needed timestep"); - for (int i = 0; i < nsub; i++) - emine[i] = bond->styles[i]->energy; + for (int i = 0; i < nsub; i++) emine[i] = bond->styles[i]->energy; - MPI_Allreduce(emine,vector,nsub,MPI_DOUBLE,MPI_SUM,world); + MPI_Allreduce(emine, vector, nsub, MPI_DOUBLE, MPI_SUM, world); } diff --git a/src/compute_com.cpp b/src/compute_com.cpp index e40fb6d9b3..539fd5dcd9 100644 --- a/src/compute_com.cpp +++ b/src/compute_com.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -13,18 +12,17 @@ ------------------------------------------------------------------------- */ #include "compute_com.h" -#include "update.h" -#include "group.h" #include "error.h" +#include "group.h" +#include "update.h" using namespace LAMMPS_NS; /* ---------------------------------------------------------------------- */ -ComputeCOM::ComputeCOM(LAMMPS *lmp, int narg, char **arg) : - Compute(lmp, narg, arg) +ComputeCOM::ComputeCOM(LAMMPS *lmp, int narg, char **arg) : Compute(lmp, narg, arg) { - if (narg != 3) error->all(FLERR,"Illegal compute com command"); + if (narg != 3) error->all(FLERR, "Illegal compute com command"); vector_flag = 1; size_vector = 3; @@ -37,7 +35,7 @@ ComputeCOM::ComputeCOM(LAMMPS *lmp, int narg, char **arg) : ComputeCOM::~ComputeCOM() { - delete [] vector; + delete[] vector; } /* ---------------------------------------------------------------------- */ @@ -54,5 +52,5 @@ void ComputeCOM::compute_vector() invoked_vector = update->ntimestep; if (group->dynamic[igroup]) masstotal = group->mass(igroup); - group->xcm(igroup,masstotal,vector); + group->xcm(igroup, masstotal, vector); } diff --git a/src/compute_deprecated.cpp b/src/compute_deprecated.cpp index 4747afdf99..fca119a456 100644 --- a/src/compute_deprecated.cpp +++ b/src/compute_deprecated.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -21,15 +20,14 @@ using namespace LAMMPS_NS; /* ---------------------------------------------------------------------- */ -ComputeDeprecated::ComputeDeprecated(LAMMPS *lmp, int narg, char **arg) : - Compute(lmp, narg, arg) +ComputeDeprecated::ComputeDeprecated(LAMMPS *lmp, int narg, char **arg) : Compute(lmp, narg, arg) { std::string my_style = style; if (my_style == "DEPRECATED") { if (lmp->comm->me == 0) - utils::logmesg(lmp,"\nCompute style 'DEPRECATED' is a dummy style\n\n"); + utils::logmesg(lmp, "\nCompute style 'DEPRECATED' is a dummy style\n\n"); return; } - error->all(FLERR,"This compute style is no longer available"); + error->all(FLERR, "This compute style is no longer available"); } diff --git a/src/compute_erotate_sphere.cpp b/src/compute_erotate_sphere.cpp index 22b7c4b46d..3e863eaf65 100644 --- a/src/compute_erotate_sphere.cpp +++ b/src/compute_erotate_sphere.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -21,22 +20,21 @@ using namespace LAMMPS_NS; -#define INERTIA 0.4 // moment of inertia prefactor for sphere +#define INERTIA 0.4 // moment of inertia prefactor for sphere /* ---------------------------------------------------------------------- */ ComputeERotateSphere::ComputeERotateSphere(LAMMPS *lmp, int narg, char **arg) : - Compute(lmp, narg, arg) + Compute(lmp, narg, arg) { - if (narg != 3) error->all(FLERR,"Illegal compute erotate/sphere command"); + if (narg != 3) error->all(FLERR, "Illegal compute erotate/sphere command"); scalar_flag = 1; extscalar = 1; // error check - if (!atom->sphere_flag) - error->all(FLERR,"Compute erotate/sphere requires atom style sphere"); + if (!atom->sphere_flag) error->all(FLERR, "Compute erotate/sphere requires atom style sphere"); } /* ---------------------------------------------------------------------- */ @@ -64,10 +62,11 @@ double ComputeERotateSphere::compute_scalar() double erotate = 0.0; for (int i = 0; i < nlocal; i++) if (mask[i] & groupbit) - erotate += (omega[i][0]*omega[i][0] + omega[i][1]*omega[i][1] + - omega[i][2]*omega[i][2]) * radius[i]*radius[i]*rmass[i]; + erotate += + (omega[i][0] * omega[i][0] + omega[i][1] * omega[i][1] + omega[i][2] * omega[i][2]) * + radius[i] * radius[i] * rmass[i]; - MPI_Allreduce(&erotate,&scalar,1,MPI_DOUBLE,MPI_SUM,world); + MPI_Allreduce(&erotate, &scalar, 1, MPI_DOUBLE, MPI_SUM, world); scalar *= pfactor; return scalar; } diff --git a/src/compute_ke.cpp b/src/compute_ke.cpp index ea011eccc1..c515522195 100644 --- a/src/compute_ke.cpp +++ b/src/compute_ke.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -15,18 +14,17 @@ #include "compute_ke.h" #include "atom.h" -#include "update.h" -#include "force.h" #include "error.h" +#include "force.h" +#include "update.h" using namespace LAMMPS_NS; /* ---------------------------------------------------------------------- */ -ComputeKE::ComputeKE(LAMMPS *lmp, int narg, char **arg) : - Compute(lmp, narg, arg) +ComputeKE::ComputeKE(LAMMPS *lmp, int narg, char **arg) : Compute(lmp, narg, arg) { - if (narg != 3) error->all(FLERR,"Illegal compute ke command"); + if (narg != 3) error->all(FLERR, "Illegal compute ke command"); scalar_flag = 1; extscalar = 1; @@ -57,15 +55,14 @@ double ComputeKE::compute_scalar() if (rmass) { for (int i = 0; i < nlocal; i++) if (mask[i] & groupbit) - ke += rmass[i] * (v[i][0]*v[i][0] + v[i][1]*v[i][1] + v[i][2]*v[i][2]); + ke += rmass[i] * (v[i][0] * v[i][0] + v[i][1] * v[i][1] + v[i][2] * v[i][2]); } else { for (int i = 0; i < nlocal; i++) if (mask[i] & groupbit) - ke += mass[type[i]] * - (v[i][0]*v[i][0] + v[i][1]*v[i][1] + v[i][2]*v[i][2]); + ke += mass[type[i]] * (v[i][0] * v[i][0] + v[i][1] * v[i][1] + v[i][2] * v[i][2]); } - MPI_Allreduce(&ke,&scalar,1,MPI_DOUBLE,MPI_SUM,world); + MPI_Allreduce(&ke, &scalar, 1, MPI_DOUBLE, MPI_SUM, world); scalar *= pfactor; return scalar; } diff --git a/src/compute_stress_atom.cpp b/src/compute_stress_atom.cpp index ac69667294..f9c24847a1 100644 --- a/src/compute_stress_atom.cpp +++ b/src/compute_stress_atom.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -33,15 +32,14 @@ using namespace LAMMPS_NS; -enum{NOBIAS,BIAS}; +enum { NOBIAS, BIAS }; /* ---------------------------------------------------------------------- */ ComputeStressAtom::ComputeStressAtom(LAMMPS *lmp, int narg, char **arg) : - Compute(lmp, narg, arg), - id_temp(nullptr), stress(nullptr) + Compute(lmp, narg, arg), id_temp(nullptr), stress(nullptr) { - if (narg < 4) error->all(FLERR,"Illegal compute stress/atom command"); + if (narg < 4) error->all(FLERR, "Illegal compute stress/atom command"); peratom_flag = 1; size_peratom_cols = 6; @@ -52,17 +50,15 @@ ComputeStressAtom::ComputeStressAtom(LAMMPS *lmp, int narg, char **arg) : // store temperature ID used by stress computation // insure it is valid for temperature computation - if (strcmp(arg[3],"NULL") == 0) id_temp = nullptr; + if (strcmp(arg[3], "NULL") == 0) + id_temp = nullptr; else { id_temp = utils::strdup(arg[3]); int icompute = modify->find_compute(id_temp); - if (icompute < 0) - error->all(FLERR,"Could not find compute stress/atom temperature ID"); + if (icompute < 0) error->all(FLERR, "Could not find compute stress/atom temperature ID"); if (modify->compute[icompute]->tempflag == 0) - error->all(FLERR, - "Compute stress/atom temperature ID does not " - "compute temperature"); + error->all(FLERR, "Compute stress/atom temperature ID does not compute temperature"); } // process optional args @@ -81,19 +77,28 @@ ComputeStressAtom::ComputeStressAtom(LAMMPS *lmp, int narg, char **arg) : fixflag = 0; int iarg = 4; while (iarg < narg) { - if (strcmp(arg[iarg],"ke") == 0) keflag = 1; - else if (strcmp(arg[iarg],"pair") == 0) pairflag = 1; - else if (strcmp(arg[iarg],"bond") == 0) bondflag = 1; - else if (strcmp(arg[iarg],"angle") == 0) angleflag = 1; - else if (strcmp(arg[iarg],"dihedral") == 0) dihedralflag = 1; - else if (strcmp(arg[iarg],"improper") == 0) improperflag = 1; - else if (strcmp(arg[iarg],"kspace") == 0) kspaceflag = 1; - else if (strcmp(arg[iarg],"fix") == 0) fixflag = 1; - else if (strcmp(arg[iarg],"virial") == 0) { + if (strcmp(arg[iarg], "ke") == 0) + keflag = 1; + else if (strcmp(arg[iarg], "pair") == 0) + pairflag = 1; + else if (strcmp(arg[iarg], "bond") == 0) + bondflag = 1; + else if (strcmp(arg[iarg], "angle") == 0) + angleflag = 1; + else if (strcmp(arg[iarg], "dihedral") == 0) + dihedralflag = 1; + else if (strcmp(arg[iarg], "improper") == 0) + improperflag = 1; + else if (strcmp(arg[iarg], "kspace") == 0) + kspaceflag = 1; + else if (strcmp(arg[iarg], "fix") == 0) + fixflag = 1; + else if (strcmp(arg[iarg], "virial") == 0) { pairflag = 1; bondflag = angleflag = dihedralflag = improperflag = 1; kspaceflag = fixflag = 1; - } else error->all(FLERR,"Illegal compute stress/atom command"); + } else + error->all(FLERR, "Illegal compute stress/atom command"); iarg++; } } @@ -105,7 +110,7 @@ ComputeStressAtom::ComputeStressAtom(LAMMPS *lmp, int narg, char **arg) : ComputeStressAtom::~ComputeStressAtom() { - delete [] id_temp; + delete[] id_temp; memory->destroy(stress); } @@ -118,24 +123,26 @@ void ComputeStressAtom::init() if (id_temp) { int icompute = modify->find_compute(id_temp); - if (icompute < 0) - error->all(FLERR,"Could not find compute stress/atom temperature ID"); + if (icompute < 0) error->all(FLERR, "Could not find compute stress/atom temperature ID"); temperature = modify->compute[icompute]; - if (temperature->tempbias) biasflag = BIAS; - else biasflag = NOBIAS; - } else biasflag = NOBIAS; + if (temperature->tempbias) + biasflag = BIAS; + else + biasflag = NOBIAS; + } else + biasflag = NOBIAS; } /* ---------------------------------------------------------------------- */ void ComputeStressAtom::compute_peratom() { - int i,j; + int i, j; double onemass; invoked_peratom = update->ntimestep; if (update->vflag_atom != invoked_peratom) - error->all(FLERR,"Per-atom virial was not tallied on needed timestep"); + error->all(FLERR, "Per-atom virial was not tallied on needed timestep"); // grow local stress array if necessary // needs to be atom->nmax in length @@ -143,7 +150,7 @@ void ComputeStressAtom::compute_peratom() if (atom->nmax > nmax) { memory->destroy(stress); nmax = atom->nmax; - memory->create(stress,nmax,6,"stress/atom:stress"); + memory->create(stress, nmax, 6, "stress/atom:stress"); array_atom = stress; } @@ -166,51 +173,44 @@ void ComputeStressAtom::compute_peratom() // clear local stress array for (i = 0; i < ntotal; i++) - for (j = 0; j < 6; j++) - stress[i][j] = 0.0; + for (j = 0; j < 6; j++) stress[i][j] = 0.0; // add in per-atom contributions from each force if (pairflag && force->pair && force->pair->compute_flag) { double **vatom = force->pair->vatom; for (i = 0; i < npair; i++) - for (j = 0; j < 6; j++) - stress[i][j] += vatom[i][j]; + for (j = 0; j < 6; j++) stress[i][j] += vatom[i][j]; } if (bondflag && force->bond) { double **vatom = force->bond->vatom; for (i = 0; i < nbond; i++) - for (j = 0; j < 6; j++) - stress[i][j] += vatom[i][j]; + for (j = 0; j < 6; j++) stress[i][j] += vatom[i][j]; } if (angleflag && force->angle) { double **vatom = force->angle->vatom; for (i = 0; i < nbond; i++) - for (j = 0; j < 6; j++) - stress[i][j] += vatom[i][j]; + for (j = 0; j < 6; j++) stress[i][j] += vatom[i][j]; } if (dihedralflag && force->dihedral) { double **vatom = force->dihedral->vatom; for (i = 0; i < nbond; i++) - for (j = 0; j < 6; j++) - stress[i][j] += vatom[i][j]; + for (j = 0; j < 6; j++) stress[i][j] += vatom[i][j]; } if (improperflag && force->improper) { double **vatom = force->improper->vatom; for (i = 0; i < nbond; i++) - for (j = 0; j < 6; j++) - stress[i][j] += vatom[i][j]; + for (j = 0; j < 6; j++) stress[i][j] += vatom[i][j]; } if (kspaceflag && force->kspace && force->kspace->compute_flag) { double **vatom = force->kspace->vatom; for (i = 0; i < nkspace; i++) - for (j = 0; j < 6; j++) - stress[i][j] += vatom[i][j]; + for (j = 0; j < 6; j++) stress[i][j] += vatom[i][j]; } // add in per-atom contributions from relevant fixes @@ -225,15 +225,13 @@ void ComputeStressAtom::compute_peratom() double **vatom = ifix->vatom; if (vatom) for (i = 0; i < nlocal; i++) - for (j = 0; j < 6; j++) - stress[i][j] += vatom[i][j]; + for (j = 0; j < 6; j++) stress[i][j] += vatom[i][j]; } } // communicate ghost virials between neighbor procs - if (force->newton || (force->kspace && force->kspace->tip4pflag)) - comm->reverse_comm(this); + if (force->newton || (force->kspace && force->kspace->tip4pflag)) comm->reverse_comm(this); // zero virial of atoms not in group // only do this after comm since ghost contributions must be included @@ -266,24 +264,24 @@ void ComputeStressAtom::compute_peratom() for (i = 0; i < nlocal; i++) if (mask[i] & groupbit) { onemass = mvv2e * rmass[i]; - stress[i][0] += onemass*v[i][0]*v[i][0]; - stress[i][1] += onemass*v[i][1]*v[i][1]; - stress[i][2] += onemass*v[i][2]*v[i][2]; - stress[i][3] += onemass*v[i][0]*v[i][1]; - stress[i][4] += onemass*v[i][0]*v[i][2]; - stress[i][5] += onemass*v[i][1]*v[i][2]; + stress[i][0] += onemass * v[i][0] * v[i][0]; + stress[i][1] += onemass * v[i][1] * v[i][1]; + stress[i][2] += onemass * v[i][2] * v[i][2]; + stress[i][3] += onemass * v[i][0] * v[i][1]; + stress[i][4] += onemass * v[i][0] * v[i][2]; + stress[i][5] += onemass * v[i][1] * v[i][2]; } } else { for (i = 0; i < nlocal; i++) if (mask[i] & groupbit) { onemass = mvv2e * mass[type[i]]; - stress[i][0] += onemass*v[i][0]*v[i][0]; - stress[i][1] += onemass*v[i][1]*v[i][1]; - stress[i][2] += onemass*v[i][2]*v[i][2]; - stress[i][3] += onemass*v[i][0]*v[i][1]; - stress[i][4] += onemass*v[i][0]*v[i][2]; - stress[i][5] += onemass*v[i][1]*v[i][2]; + stress[i][0] += onemass * v[i][0] * v[i][0]; + stress[i][1] += onemass * v[i][1] * v[i][1]; + stress[i][2] += onemass * v[i][2] * v[i][2]; + stress[i][3] += onemass * v[i][0] * v[i][1]; + stress[i][4] += onemass * v[i][0] * v[i][2]; + stress[i][5] += onemass * v[i][1] * v[i][2]; } } @@ -292,35 +290,34 @@ void ComputeStressAtom::compute_peratom() // invoke temperature if it hasn't been already // this insures bias factor is pre-computed - if (keflag && temperature->invoked_scalar != update->ntimestep) - temperature->compute_scalar(); + if (keflag && temperature->invoked_scalar != update->ntimestep) temperature->compute_scalar(); if (rmass) { for (i = 0; i < nlocal; i++) if (mask[i] & groupbit) { - temperature->remove_bias(i,v[i]); + temperature->remove_bias(i, v[i]); onemass = mvv2e * rmass[i]; - stress[i][0] += onemass*v[i][0]*v[i][0]; - stress[i][1] += onemass*v[i][1]*v[i][1]; - stress[i][2] += onemass*v[i][2]*v[i][2]; - stress[i][3] += onemass*v[i][0]*v[i][1]; - stress[i][4] += onemass*v[i][0]*v[i][2]; - stress[i][5] += onemass*v[i][1]*v[i][2]; - temperature->restore_bias(i,v[i]); + stress[i][0] += onemass * v[i][0] * v[i][0]; + stress[i][1] += onemass * v[i][1] * v[i][1]; + stress[i][2] += onemass * v[i][2] * v[i][2]; + stress[i][3] += onemass * v[i][0] * v[i][1]; + stress[i][4] += onemass * v[i][0] * v[i][2]; + stress[i][5] += onemass * v[i][1] * v[i][2]; + temperature->restore_bias(i, v[i]); } } else { for (i = 0; i < nlocal; i++) if (mask[i] & groupbit) { - temperature->remove_bias(i,v[i]); + temperature->remove_bias(i, v[i]); onemass = mvv2e * mass[type[i]]; - stress[i][0] += onemass*v[i][0]*v[i][0]; - stress[i][1] += onemass*v[i][1]*v[i][1]; - stress[i][2] += onemass*v[i][2]*v[i][2]; - stress[i][3] += onemass*v[i][0]*v[i][1]; - stress[i][4] += onemass*v[i][0]*v[i][2]; - stress[i][5] += onemass*v[i][1]*v[i][2]; - temperature->restore_bias(i,v[i]); + stress[i][0] += onemass * v[i][0] * v[i][0]; + stress[i][1] += onemass * v[i][1] * v[i][1]; + stress[i][2] += onemass * v[i][2] * v[i][2]; + stress[i][3] += onemass * v[i][0] * v[i][1]; + stress[i][4] += onemass * v[i][0] * v[i][2]; + stress[i][5] += onemass * v[i][1] * v[i][2]; + temperature->restore_bias(i, v[i]); } } } @@ -344,7 +341,7 @@ void ComputeStressAtom::compute_peratom() int ComputeStressAtom::pack_reverse_comm(int n, int first, double *buf) { - int i,m,last; + int i, m, last; m = 0; last = first + n; @@ -363,7 +360,7 @@ int ComputeStressAtom::pack_reverse_comm(int n, int first, double *buf) void ComputeStressAtom::unpack_reverse_comm(int n, int *list, double *buf) { - int i,j,m; + int i, j, m; m = 0; for (i = 0; i < n; i++) { @@ -383,6 +380,6 @@ void ComputeStressAtom::unpack_reverse_comm(int n, int *list, double *buf) double ComputeStressAtom::memory_usage() { - double bytes = (double)nmax*6 * sizeof(double); + double bytes = (double) nmax * 6 * sizeof(double); return bytes; } diff --git a/src/dihedral_deprecated.cpp b/src/dihedral_deprecated.cpp index 57ea7f1afa..63afe28dff 100644 --- a/src/dihedral_deprecated.cpp +++ b/src/dihedral_deprecated.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -23,7 +22,6 @@ #include "error.h" #include "force.h" - using namespace LAMMPS_NS; /* ---------------------------------------------------------------------- */ @@ -36,15 +34,15 @@ void DihedralDeprecated::settings(int, char **) // so when this is called, our style was just added at the end // of the list of substyles - if (utils::strmatch(my_style,"^hybrid")) { + if (utils::strmatch(my_style, "^hybrid")) { auto hybrid = dynamic_cast(force->dihedral); my_style = hybrid->keywords[hybrid->nstyles]; } if (my_style == "DEPRECATED") { if (lmp->comm->me == 0) - utils::logmesg(lmp,"\nDihedral style 'DEPRECATED' is a dummy style\n\n"); + utils::logmesg(lmp, "\nDihedral style 'DEPRECATED' is a dummy style\n\n"); return; } - error->all(FLERR,"This dihedral style is no longer available"); + error->all(FLERR, "This dihedral style is no longer available"); } diff --git a/src/dump_deprecated.cpp b/src/dump_deprecated.cpp index fdd9d06dbc..1c4fb59390 100644 --- a/src/dump_deprecated.cpp +++ b/src/dump_deprecated.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -21,15 +20,13 @@ using namespace LAMMPS_NS; /* ---------------------------------------------------------------------- */ -DumpDeprecated::DumpDeprecated(LAMMPS *lmp, int narg, char **arg) : - Dump(lmp, narg, arg) +DumpDeprecated::DumpDeprecated(LAMMPS *lmp, int narg, char **arg) : Dump(lmp, narg, arg) { std::string my_style = style; if (my_style == "DEPRECATED") { - if (lmp->comm->me == 0) - utils::logmesg(lmp,"\nDump style 'DEPRECATED' is a dummy style\n\n"); + if (lmp->comm->me == 0) utils::logmesg(lmp, "\nDump style 'DEPRECATED' is a dummy style\n\n"); return; } - error->all(FLERR,"This dump style is no longer available"); + error->all(FLERR, "This dump style is no longer available"); } diff --git a/src/fix_deprecated.cpp b/src/fix_deprecated.cpp index 017ae9ff1b..23e219c7c1 100644 --- a/src/fix_deprecated.cpp +++ b/src/fix_deprecated.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -17,23 +16,21 @@ #include "comm.h" #include "error.h" - using namespace LAMMPS_NS; /* ---------------------------------------------------------------------- */ -FixDeprecated::FixDeprecated(LAMMPS *lmp, int narg, char **arg) : - Fix(lmp, narg, arg) +FixDeprecated::FixDeprecated(LAMMPS *lmp, int narg, char **arg) : Fix(lmp, narg, arg) { std::string my_style = style; if (my_style == "DEPRECATED") { - if (lmp->comm->me == 0) - utils::logmesg(lmp,"\nFix style 'DEPRECATED' is a dummy style\n\n"); + if (lmp->comm->me == 0) utils::logmesg(lmp, "\nFix style 'DEPRECATED' is a dummy style\n\n"); return; - } else if (utils::strmatch(my_style,"^ave/spatial")) { + } else if (utils::strmatch(my_style, "^ave/spatial")) { if (lmp->comm->me == 0) - utils::logmesg(lmp,"\nFix styles 'ave/spatial' and 'ave/spatial/sphere'" + utils::logmesg(lmp, + "\nFix styles 'ave/spatial' and 'ave/spatial/sphere'" " have been replaced\nby the more general fix ave/chunk " "and compute chunk/atom commands.\nAll ave/spatial and " "ave/spatial/sphere functionality is available in these" @@ -44,14 +41,16 @@ FixDeprecated::FixDeprecated(LAMMPS *lmp, int narg, char **arg) : "compute chunk/atom:\n dim, origin, delta, region, " "bound, discard, units\n\n"); } else if (my_style == "lb/pc") { - utils::logmesg(lmp,"\nFix style 'lb/pc' has been removed from the LATBOLTZ" - " package; 'fix nve' can be used in its place.\n\n"); + utils::logmesg(lmp, + "\nFix style 'lb/pc' has been removed from the LATBOLTZ" + " package; 'fix nve' can be used in its place.\n\n"); } else if (my_style == "lb/rigid/pc/sphere") { - utils::logmesg(lmp,"\nFix style 'lb/rigid/pc/sphere' has been removed from" + utils::logmesg(lmp, + "\nFix style 'lb/rigid/pc/sphere' has been removed from" " the LATBOLTZ package; 'fix rigid' can be used in its place.\n\n"); } else if (my_style == "client/md") { if (lmp->comm->me == 0) utils::logmesg(lmp, "\nThe MESSAGE package has been replaced by the MDI package.\n\n"); } - error->all(FLERR,"This fix style is no longer available"); + error->all(FLERR, "This fix style is no longer available"); } diff --git a/src/fix_nph.cpp b/src/fix_nph.cpp index 2f007c803e..0a8f67e4b0 100644 --- a/src/fix_nph.cpp +++ b/src/fix_nph.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -22,13 +21,10 @@ using namespace FixConst; /* ---------------------------------------------------------------------- */ -FixNPH::FixNPH(LAMMPS *lmp, int narg, char **arg) : - FixNH(lmp, narg, arg) +FixNPH::FixNPH(LAMMPS *lmp, int narg, char **arg) : FixNH(lmp, narg, arg) { - if (tstat_flag) - error->all(FLERR,"Temperature control can not be used with fix nph"); - if (!pstat_flag) - error->all(FLERR,"Pressure control must be used with fix nph"); + if (tstat_flag) error->all(FLERR, "Temperature control can not be used with fix nph"); + if (!pstat_flag) error->all(FLERR, "Pressure control must be used with fix nph"); // create a new compute temp style // id = fix-ID + temp @@ -36,7 +32,7 @@ FixNPH::FixNPH(LAMMPS *lmp, int narg, char **arg) : // and thus its KE/temperature contribution should use group all id_temp = utils::strdup(std::string(id) + "_temp"); - modify->add_compute(fmt::format("{} all temp",id_temp)); + modify->add_compute(fmt::format("{} all temp", id_temp)); tcomputeflag = 1; // create a new compute pressure style @@ -44,6 +40,6 @@ FixNPH::FixNPH(LAMMPS *lmp, int narg, char **arg) : // pass id_temp as 4th arg to pressure constructor id_press = utils::strdup(std::string(id) + "_press"); - modify->add_compute(fmt::format("{} all pressure {}",id_press, id_temp)); + modify->add_compute(fmt::format("{} all pressure {}", id_press, id_temp)); pcomputeflag = 1; } diff --git a/src/fix_nph_sphere.cpp b/src/fix_nph_sphere.cpp index bd51c3b7f7..75aab70f06 100644 --- a/src/fix_nph_sphere.cpp +++ b/src/fix_nph_sphere.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -22,13 +21,10 @@ using namespace FixConst; /* ---------------------------------------------------------------------- */ -FixNPHSphere::FixNPHSphere(LAMMPS *lmp, int narg, char **arg) : - FixNHSphere(lmp, narg, arg) +FixNPHSphere::FixNPHSphere(LAMMPS *lmp, int narg, char **arg) : FixNHSphere(lmp, narg, arg) { - if (tstat_flag) - error->all(FLERR,"Temperature control can not be used with fix nph/sphere"); - if (!pstat_flag) - error->all(FLERR,"Pressure control must be used with fix nph/sphere"); + if (tstat_flag) error->all(FLERR, "Temperature control can not be used with fix nph/sphere"); + if (!pstat_flag) error->all(FLERR, "Pressure control must be used with fix nph/sphere"); // create a new compute temp style // id = fix-ID + temp @@ -36,7 +32,7 @@ FixNPHSphere::FixNPHSphere(LAMMPS *lmp, int narg, char **arg) : // and thus its KE/temperature contribution should use group all id_temp = utils::strdup(std::string(id) + "_temp"); - modify->add_compute(fmt::format("{} all temp/sphere",id_temp)); + modify->add_compute(fmt::format("{} all temp/sphere", id_temp)); tcomputeflag = 1; // create a new compute pressure style @@ -44,6 +40,6 @@ FixNPHSphere::FixNPHSphere(LAMMPS *lmp, int narg, char **arg) : // pass id_temp as 4th arg to pressure constructor id_press = utils::strdup(std::string(id) + "_press"); - modify->add_compute(fmt::format("{} all pressure {}",id_press, id_temp)); + modify->add_compute(fmt::format("{} all pressure {}", id_press, id_temp)); pcomputeflag = 1; } diff --git a/src/fix_npt.cpp b/src/fix_npt.cpp index fb02919041..ff94ae678d 100644 --- a/src/fix_npt.cpp +++ b/src/fix_npt.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -22,13 +21,10 @@ using namespace FixConst; /* ---------------------------------------------------------------------- */ -FixNPT::FixNPT(LAMMPS *lmp, int narg, char **arg) : - FixNH(lmp, narg, arg) +FixNPT::FixNPT(LAMMPS *lmp, int narg, char **arg) : FixNH(lmp, narg, arg) { - if (!tstat_flag) - error->all(FLERR,"Temperature control must be used with fix npt"); - if (!pstat_flag) - error->all(FLERR,"Pressure control must be used with fix npt"); + if (!tstat_flag) error->all(FLERR, "Temperature control must be used with fix npt"); + if (!pstat_flag) error->all(FLERR, "Pressure control must be used with fix npt"); // create a new compute temp style // id = fix-ID + temp @@ -36,7 +32,7 @@ FixNPT::FixNPT(LAMMPS *lmp, int narg, char **arg) : // and thus its KE/temperature contribution should use group all id_temp = utils::strdup(std::string(id) + "_temp"); - modify->add_compute(fmt::format("{} all temp",id_temp)); + modify->add_compute(fmt::format("{} all temp", id_temp)); tcomputeflag = 1; // create a new compute pressure style @@ -44,6 +40,6 @@ FixNPT::FixNPT(LAMMPS *lmp, int narg, char **arg) : // pass id_temp as 4th arg to pressure constructor id_press = utils::strdup(std::string(id) + "_press"); - modify->add_compute(fmt::format("{} all pressure {}",id_press, id_temp)); + modify->add_compute(fmt::format("{} all pressure {}", id_press, id_temp)); pcomputeflag = 1; } diff --git a/src/fix_npt_sphere.cpp b/src/fix_npt_sphere.cpp index fe5d5df6f6..64279b1099 100644 --- a/src/fix_npt_sphere.cpp +++ b/src/fix_npt_sphere.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -22,13 +21,10 @@ using namespace FixConst; /* ---------------------------------------------------------------------- */ -FixNPTSphere::FixNPTSphere(LAMMPS *lmp, int narg, char **arg) : - FixNHSphere(lmp, narg, arg) +FixNPTSphere::FixNPTSphere(LAMMPS *lmp, int narg, char **arg) : FixNHSphere(lmp, narg, arg) { - if (!tstat_flag) - error->all(FLERR,"Temperature control must be used with fix npt/sphere"); - if (!pstat_flag) - error->all(FLERR,"Pressure control must be used with fix npt/sphere"); + if (!tstat_flag) error->all(FLERR, "Temperature control must be used with fix npt/sphere"); + if (!pstat_flag) error->all(FLERR, "Pressure control must be used with fix npt/sphere"); // create a new compute temp style // id = fix-ID + temp @@ -36,7 +32,7 @@ FixNPTSphere::FixNPTSphere(LAMMPS *lmp, int narg, char **arg) : // and thus its KE/temperature contribution should use group all id_temp = utils::strdup(std::string(id) + "_temp"); - modify->add_compute(fmt::format("{} all temp/sphere",id_temp)); + modify->add_compute(fmt::format("{} all temp/sphere", id_temp)); tcomputeflag = 1; // create a new compute pressure style @@ -44,6 +40,6 @@ FixNPTSphere::FixNPTSphere(LAMMPS *lmp, int narg, char **arg) : // pass id_temp as 4th arg to pressure constructor id_press = utils::strdup(std::string(id) + "_press"); - modify->add_compute(fmt::format("{} all pressure {}",id_press, id_temp)); + modify->add_compute(fmt::format("{} all pressure {}", id_press, id_temp)); pcomputeflag = 1; } diff --git a/src/fix_nvt.cpp b/src/fix_nvt.cpp index e27f3ccc67..11404bf90d 100644 --- a/src/fix_nvt.cpp +++ b/src/fix_nvt.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -23,18 +22,15 @@ using namespace FixConst; /* ---------------------------------------------------------------------- */ -FixNVT::FixNVT(LAMMPS *lmp, int narg, char **arg) : - FixNH(lmp, narg, arg) +FixNVT::FixNVT(LAMMPS *lmp, int narg, char **arg) : FixNH(lmp, narg, arg) { - if (!tstat_flag) - error->all(FLERR,"Temperature control must be used with fix nvt"); - if (pstat_flag) - error->all(FLERR,"Pressure control can not be used with fix nvt"); + if (!tstat_flag) error->all(FLERR, "Temperature control must be used with fix nvt"); + if (pstat_flag) error->all(FLERR, "Pressure control can not be used with fix nvt"); // create a new compute temp style // id = fix-ID + temp id_temp = utils::strdup(std::string(id) + "_temp"); - modify->add_compute(fmt::format("{} {} temp",id_temp,group->names[igroup])); + modify->add_compute(fmt::format("{} {} temp", id_temp, group->names[igroup])); tcomputeflag = 1; } diff --git a/src/improper_deprecated.cpp b/src/improper_deprecated.cpp index b1e3d3511b..7b757e62e1 100644 --- a/src/improper_deprecated.cpp +++ b/src/improper_deprecated.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories diff --git a/src/kspace_deprecated.cpp b/src/kspace_deprecated.cpp index 46a3e6df6b..62605542d8 100644 --- a/src/kspace_deprecated.cpp +++ b/src/kspace_deprecated.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -19,8 +18,8 @@ #include "kspace_deprecated.h" #include "comm.h" -#include "force.h" #include "error.h" +#include "force.h" using namespace LAMMPS_NS; @@ -31,11 +30,8 @@ void KSpaceDeprecated::settings(int, char **) std::string my_style = force->kspace_style; if (my_style == "DEPRECATED") { - if (lmp->comm->me == 0) - utils::logmesg(lmp,"\nKSpace style 'DEPRECATED' is a dummy style\n\n"); + if (lmp->comm->me == 0) utils::logmesg(lmp, "\nKSpace style 'DEPRECATED' is a dummy style\n\n"); return; } - error->all(FLERR,"This kspace style is no longer available"); + error->all(FLERR, "This kspace style is no longer available"); } - - diff --git a/src/minimize.cpp b/src/minimize.cpp index 206bc51914..e9c6ec25b3 100644 --- a/src/minimize.cpp +++ b/src/minimize.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -32,28 +31,26 @@ Minimize::Minimize(LAMMPS *lmp) : Command(lmp) {} void Minimize::command(int narg, char **arg) { - if (narg != 4) error->all(FLERR,"Illegal minimize command"); + if (narg != 4) error->all(FLERR, "Illegal minimize command"); if (domain->box_exist == 0) - error->all(FLERR,"Minimize command before simulation box is defined"); + error->all(FLERR, "Minimize command before simulation box is defined"); // ignore minimize command, if walltime limit was already reached if (timer->is_timeout()) return; - update->etol = utils::numeric(FLERR,arg[0],false,lmp); - update->ftol = utils::numeric(FLERR,arg[1],false,lmp); - update->nsteps = utils::inumeric(FLERR,arg[2],false,lmp); - update->max_eval = utils::inumeric(FLERR,arg[3],false,lmp); + update->etol = utils::numeric(FLERR, arg[0], false, lmp); + update->ftol = utils::numeric(FLERR, arg[1], false, lmp); + update->nsteps = utils::inumeric(FLERR, arg[2], false, lmp); + update->max_eval = utils::inumeric(FLERR, arg[3], false, lmp); - if (update->etol < 0.0 || update->ftol < 0.0) - error->all(FLERR,"Illegal minimize command"); + if (update->etol < 0.0 || update->ftol < 0.0) error->all(FLERR, "Illegal minimize command"); if (lmp->citeme) lmp->citeme->flush(); update->whichflag = 2; update->beginstep = update->firststep = update->ntimestep; update->endstep = update->laststep = update->firststep + update->nsteps; - if (update->laststep < 0) - error->all(FLERR,"Too many iterations"); + if (update->laststep < 0) error->all(FLERR, "Too many iterations"); lmp->init(); timer->init_timeout(); diff --git a/src/pair_deprecated.cpp b/src/pair_deprecated.cpp index 691eff124f..cafb0ce7c0 100644 --- a/src/pair_deprecated.cpp +++ b/src/pair_deprecated.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -18,11 +17,10 @@ #include "pair_deprecated.h" -#include "pair_hybrid.h" #include "comm.h" -#include "force.h" #include "error.h" - +#include "force.h" +#include "pair_hybrid.h" using namespace LAMMPS_NS; @@ -35,21 +33,21 @@ void PairDeprecated::settings(int, char **) // hybrid substyles are created in PairHybrid::settings(), so when this is // called, our style was just added at the end of the list of substyles - if (utils::strmatch(my_style,"^hybrid")) { + if (utils::strmatch(my_style, "^hybrid")) { auto hybrid = dynamic_cast(force->pair); my_style = hybrid->keywords[hybrid->nstyles]; } if (my_style == "DEPRECATED") { - if (lmp->comm->me == 0) - utils::logmesg(lmp,"\nPair style 'DEPRECATED' is a dummy style\n\n"); + if (lmp->comm->me == 0) utils::logmesg(lmp, "\nPair style 'DEPRECATED' is a dummy style\n\n"); return; } if (my_style == "reax") { if (lmp->comm->me == 0) - utils::logmesg(lmp,"\nPair style 'reax' has been removed from LAMMPS " + utils::logmesg(lmp, + "\nPair style 'reax' has been removed from LAMMPS " "after the 12 December 2018 version\n\n"); } - error->all(FLERR,"This pair style is no longer available"); + error->all(FLERR, "This pair style is no longer available"); } diff --git a/src/region_deprecated.cpp b/src/region_deprecated.cpp index e6d81fdc44..bc59d77259 100644 --- a/src/region_deprecated.cpp +++ b/src/region_deprecated.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -17,20 +16,17 @@ #include "comm.h" #include "error.h" - using namespace LAMMPS_NS; /* ---------------------------------------------------------------------- */ -RegionDeprecated::RegionDeprecated(LAMMPS *lmp, int narg, char **arg) : - Region(lmp, narg, arg) +RegionDeprecated::RegionDeprecated(LAMMPS *lmp, int narg, char **arg) : Region(lmp, narg, arg) { std::string my_style = style; if (my_style == "DEPRECATED") { - if (lmp->comm->me == 0) - utils::logmesg(lmp,"\nRegion style 'DEPRECATED' is a dummy style\n\n"); + if (lmp->comm->me == 0) utils::logmesg(lmp, "\nRegion style 'DEPRECATED' is a dummy style\n\n"); return; } - error->all(FLERR,"This region style is no longer available"); + error->all(FLERR, "This region style is no longer available"); } From cd8bef3b0b3c60ed5e1b9e9388efcb7848adcb31 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sun, 22 May 2022 07:04:35 -0400 Subject: [PATCH 189/585] enable and apply clang-format --- src/compute_dihedral.cpp | 29 ++++++++++------------ src/compute_improper.cpp | 33 +++++++++++--------------- src/fix_dummy.cpp | 31 ++++++++++++++---------- src/fix_nve_noforce.cpp | 12 ++++------ src/fix_nvt_sphere.cpp | 13 ++++------ src/fix_wall_harmonic.cpp | 30 ++++++++++++----------- src/fix_wall_morse.cpp | 31 +++++++++++++----------- src/npair_copy.cpp | 1 - src/npair_full_bin_atomonly.cpp | 14 +++++------ src/npair_halffull_newtoff.cpp | 8 +++---- src/npair_skip_size.cpp | 8 +++---- src/nstencil_full_bin_2d.cpp | 6 ++--- src/nstencil_full_bin_3d.cpp | 7 +++--- src/nstencil_full_ghost_bin_2d.cpp | 7 +++--- src/nstencil_full_ghost_bin_3d.cpp | 7 +++--- src/nstencil_full_multi_2d.cpp | 6 ++--- src/nstencil_full_multi_old_2d.cpp | 9 ++++--- src/nstencil_full_multi_old_3d.cpp | 9 ++++--- src/nstencil_half_bin_2d.cpp | 6 ++--- src/nstencil_half_bin_2d_tri.cpp | 9 +++---- src/nstencil_half_bin_3d.cpp | 7 +++--- src/nstencil_half_bin_3d_tri.cpp | 10 ++++---- src/nstencil_half_multi_old_2d.cpp | 12 ++++------ src/nstencil_half_multi_old_2d_tri.cpp | 12 ++++------ src/nstencil_half_multi_old_3d.cpp | 12 ++++------ src/nstencil_half_multi_old_3d_tri.cpp | 12 ++++------ src/ntopo_bond_all.cpp | 28 ++++++++++------------ src/ntopo_bond_partial.cpp | 28 ++++++++++------------ src/reader.cpp | 20 ++++++++-------- src/write_dump.cpp | 31 +++++++++++------------- 30 files changed, 202 insertions(+), 246 deletions(-) diff --git a/src/compute_dihedral.cpp b/src/compute_dihedral.cpp index 86fd1b116e..2fda5b1f1c 100644 --- a/src/compute_dihedral.cpp +++ b/src/compute_dihedral.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -25,10 +24,9 @@ using namespace LAMMPS_NS; /* ---------------------------------------------------------------------- */ ComputeDihedral::ComputeDihedral(LAMMPS *lmp, int narg, char **arg) : - Compute(lmp, narg, arg), - emine(nullptr) + Compute(lmp, narg, arg), emine(nullptr) { - if (narg != 3) error->all(FLERR,"Illegal compute dihedral command"); + if (narg != 3) error->all(FLERR, "Illegal compute dihedral command"); vector_flag = 1; extvector = 1; @@ -37,9 +35,8 @@ ComputeDihedral::ComputeDihedral(LAMMPS *lmp, int narg, char **arg) : // check if dihedral style hybrid exists - dihedral = dynamic_cast( force->dihedral_match("hybrid")); - if (!dihedral) - error->all(FLERR, "Dihedral style for compute dihedral command is not hybrid"); + dihedral = dynamic_cast(force->dihedral_match("hybrid")); + if (!dihedral) error->all(FLERR, "Dihedral style for compute dihedral command is not hybrid"); size_vector = nsub = dihedral->nstyles; emine = new double[nsub]; @@ -50,8 +47,8 @@ ComputeDihedral::ComputeDihedral(LAMMPS *lmp, int narg, char **arg) : ComputeDihedral::~ComputeDihedral() { - delete [] emine; - delete [] vector; + delete[] emine; + delete[] vector; } /* ---------------------------------------------------------------------- */ @@ -60,11 +57,10 @@ void ComputeDihedral::init() { // recheck dihedral style in case it has been changed - dihedral = dynamic_cast( force->dihedral_match("hybrid")); - if (!dihedral) - error->all(FLERR, "Dihedral style for compute dihedral command is not hybrid"); + dihedral = dynamic_cast(force->dihedral_match("hybrid")); + if (!dihedral) error->all(FLERR, "Dihedral style for compute dihedral command is not hybrid"); if (dihedral->nstyles != nsub) - error->all(FLERR,"Dihedral style for compute dihedral command has changed"); + error->all(FLERR, "Dihedral style for compute dihedral command has changed"); } /* ---------------------------------------------------------------------- */ @@ -73,10 +69,9 @@ void ComputeDihedral::compute_vector() { invoked_vector = update->ntimestep; if (update->eflag_global != invoked_vector) - error->all(FLERR,"Energy was not tallied on needed timestep"); + error->all(FLERR, "Energy was not tallied on needed timestep"); - for (int i = 0; i < nsub; i++) - emine[i] = dihedral->styles[i]->energy; + for (int i = 0; i < nsub; i++) emine[i] = dihedral->styles[i]->energy; - MPI_Allreduce(emine,vector,nsub,MPI_DOUBLE,MPI_SUM,world); + MPI_Allreduce(emine, vector, nsub, MPI_DOUBLE, MPI_SUM, world); } diff --git a/src/compute_improper.cpp b/src/compute_improper.cpp index 3e0780be49..d2b426c5b3 100644 --- a/src/compute_improper.cpp +++ b/src/compute_improper.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -14,21 +13,20 @@ #include "compute_improper.h" -#include "update.h" +#include "error.h" #include "force.h" #include "improper.h" #include "improper_hybrid.h" -#include "error.h" +#include "update.h" using namespace LAMMPS_NS; /* ---------------------------------------------------------------------- */ ComputeImproper::ComputeImproper(LAMMPS *lmp, int narg, char **arg) : - Compute(lmp, narg, arg), - emine(nullptr) + Compute(lmp, narg, arg), emine(nullptr) { - if (narg != 3) error->all(FLERR,"Illegal compute improper command"); + if (narg != 3) error->all(FLERR, "Illegal compute improper command"); vector_flag = 1; extvector = 1; @@ -37,9 +35,8 @@ ComputeImproper::ComputeImproper(LAMMPS *lmp, int narg, char **arg) : // check if improper style hybrid exists - improper = dynamic_cast( force->improper_match("hybrid")); - if (!improper) - error->all(FLERR, "Improper style for compute improper command is not hybrid"); + improper = dynamic_cast(force->improper_match("hybrid")); + if (!improper) error->all(FLERR, "Improper style for compute improper command is not hybrid"); size_vector = nsub = improper->nstyles; emine = new double[nsub]; @@ -50,8 +47,8 @@ ComputeImproper::ComputeImproper(LAMMPS *lmp, int narg, char **arg) : ComputeImproper::~ComputeImproper() { - delete [] emine; - delete [] vector; + delete[] emine; + delete[] vector; } /* ---------------------------------------------------------------------- */ @@ -60,11 +57,10 @@ void ComputeImproper::init() { // recheck improper style in case it has been changed - improper = dynamic_cast( force->improper_match("hybrid")); - if (!improper) - error->all(FLERR, "Improper style for compute improper command is not hybrid"); + improper = dynamic_cast(force->improper_match("hybrid")); + if (!improper) error->all(FLERR, "Improper style for compute improper command is not hybrid"); if (improper->nstyles != nsub) - error->all(FLERR,"Improper style for compute improper command has changed"); + error->all(FLERR, "Improper style for compute improper command has changed"); } /* ---------------------------------------------------------------------- */ @@ -73,10 +69,9 @@ void ComputeImproper::compute_vector() { invoked_vector = update->ntimestep; if (update->eflag_global != invoked_vector) - error->all(FLERR,"Energy was not tallied on needed timestep"); + error->all(FLERR, "Energy was not tallied on needed timestep"); - for (int i = 0; i < nsub; i++) - emine[i] = improper->styles[i]->energy; + for (int i = 0; i < nsub; i++) emine[i] = improper->styles[i]->energy; - MPI_Allreduce(emine,vector,nsub,MPI_DOUBLE,MPI_SUM,world); + MPI_Allreduce(emine, vector, nsub, MPI_DOUBLE, MPI_SUM, world); } diff --git a/src/fix_dummy.cpp b/src/fix_dummy.cpp index d8a4df173b..eb8c08f43e 100644 --- a/src/fix_dummy.cpp +++ b/src/fix_dummy.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -13,16 +12,16 @@ ------------------------------------------------------------------------- */ #include "fix_dummy.h" -#include #include "error.h" +#include + using namespace LAMMPS_NS; using namespace FixConst; /* ---------------------------------------------------------------------- */ -FixDummy::FixDummy(LAMMPS *lmp, int narg, char **arg) : - Fix(lmp, narg, arg) +FixDummy::FixDummy(LAMMPS *lmp, int narg, char **arg) : Fix(lmp, narg, arg) { // process optional args // customize here and in setmask() by adding a new keyword from fix.h @@ -39,14 +38,22 @@ FixDummy::FixDummy(LAMMPS *lmp, int narg, char **arg) : int iarg = 3; while (iarg < narg) { - if (strcmp(arg[iarg],"initial_integrate") == 0) initial_integrate_flag = 1; - else if (strcmp(arg[iarg],"final_integrate") == 0) final_integrate_flag = 1; - else if (strcmp(arg[iarg],"pre_exchange") == 0) pre_exchange_flag = 1; - else if (strcmp(arg[iarg],"pre_neighbor") == 0) pre_neighbor_flag = 1; - else if (strcmp(arg[iarg],"pre_force") == 0) pre_force_flag = 1; - else if (strcmp(arg[iarg],"post_force") == 0) post_force_flag = 1; - else if (strcmp(arg[iarg],"end_of_step") == 0) end_of_step_flag = 1; - else error->all(FLERR,"Illegal fix DUMMY command"); + if (strcmp(arg[iarg], "initial_integrate") == 0) + initial_integrate_flag = 1; + else if (strcmp(arg[iarg], "final_integrate") == 0) + final_integrate_flag = 1; + else if (strcmp(arg[iarg], "pre_exchange") == 0) + pre_exchange_flag = 1; + else if (strcmp(arg[iarg], "pre_neighbor") == 0) + pre_neighbor_flag = 1; + else if (strcmp(arg[iarg], "pre_force") == 0) + pre_force_flag = 1; + else if (strcmp(arg[iarg], "post_force") == 0) + post_force_flag = 1; + else if (strcmp(arg[iarg], "end_of_step") == 0) + end_of_step_flag = 1; + else + error->all(FLERR, "Illegal fix DUMMY command"); iarg++; } } diff --git a/src/fix_nve_noforce.cpp b/src/fix_nve_noforce.cpp index d043dcbd4a..7b79dcc267 100644 --- a/src/fix_nve_noforce.cpp +++ b/src/fix_nve_noforce.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -24,10 +23,9 @@ using namespace FixConst; /* ---------------------------------------------------------------------- */ -FixNVENoforce::FixNVENoforce(LAMMPS *lmp, int narg, char **arg) : - Fix(lmp, narg, arg) +FixNVENoforce::FixNVENoforce(LAMMPS *lmp, int narg, char **arg) : Fix(lmp, narg, arg) { - if (narg != 3) error->all(FLERR,"Illegal fix nve/noforce command"); + if (narg != 3) error->all(FLERR, "Illegal fix nve/noforce command"); time_integrate = 1; } @@ -48,8 +46,8 @@ void FixNVENoforce::init() { dtv = update->dt; - if (utils::strmatch(update->integrate_style,"^respa")) - step_respa = (dynamic_cast( update->integrate))->step; + if (utils::strmatch(update->integrate_style, "^respa")) + step_respa = (dynamic_cast(update->integrate))->step; } /* ---------------------------------------------------------------------- */ @@ -75,7 +73,7 @@ void FixNVENoforce::initial_integrate(int /*vflag*/) void FixNVENoforce::initial_integrate_respa(int vflag, int ilevel, int flag) { - if (flag) return; // only used by NPT,NPH + if (flag) return; // only used by NPT,NPH dtv = step_respa[ilevel]; diff --git a/src/fix_nvt_sphere.cpp b/src/fix_nvt_sphere.cpp index aff4462356..349da470c7 100644 --- a/src/fix_nvt_sphere.cpp +++ b/src/fix_nvt_sphere.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -23,19 +22,15 @@ using namespace FixConst; /* ---------------------------------------------------------------------- */ -FixNVTSphere::FixNVTSphere(LAMMPS *lmp, int narg, char **arg) : - FixNHSphere(lmp, narg, arg) +FixNVTSphere::FixNVTSphere(LAMMPS *lmp, int narg, char **arg) : FixNHSphere(lmp, narg, arg) { - if (!tstat_flag) - error->all(FLERR,"Temperature control must be used with fix nvt/sphere"); - if (pstat_flag) - error->all(FLERR,"Pressure control can not be used with fix nvt/sphere"); + if (!tstat_flag) error->all(FLERR, "Temperature control must be used with fix nvt/sphere"); + if (pstat_flag) error->all(FLERR, "Pressure control can not be used with fix nvt/sphere"); // create a new compute temp style // id = fix-ID + temp id_temp = utils::strdup(std::string(id) + "_temp"); - modify->add_compute(fmt::format("{} {} temp/sphere", - id_temp,group->names[igroup])); + modify->add_compute(fmt::format("{} {} temp/sphere", id_temp, group->names[igroup])); tcomputeflag = 1; } diff --git a/src/fix_wall_harmonic.cpp b/src/fix_wall_harmonic.cpp index 1afca23c96..4b55dde8aa 100644 --- a/src/fix_wall_harmonic.cpp +++ b/src/fix_wall_harmonic.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -21,8 +20,7 @@ using namespace FixConst; /* ---------------------------------------------------------------------- */ -FixWallHarmonic::FixWallHarmonic(LAMMPS *lmp, int narg, char **arg) : - FixWall(lmp, narg, arg) +FixWallHarmonic::FixWallHarmonic(LAMMPS *lmp, int narg, char **arg) : FixWall(lmp, narg, arg) { dynamic_group_allow = 1; } @@ -36,7 +34,7 @@ FixWallHarmonic::FixWallHarmonic(LAMMPS *lmp, int narg, char **arg) : void FixWallHarmonic::wall_particle(int m, int which, double coord) { - double delta,dr,fwall; + double delta, dr, fwall; double vn; double **x = atom->x; @@ -52,25 +50,29 @@ void FixWallHarmonic::wall_particle(int m, int which, double coord) for (int i = 0; i < nlocal; i++) if (mask[i] & groupbit) { - if (side < 0) delta = x[i][dim] - coord; - else delta = coord - x[i][dim]; + if (side < 0) + delta = x[i][dim] - coord; + else + delta = coord - x[i][dim]; if (delta >= cutoff[m]) continue; if (delta <= 0.0) { onflag = 1; continue; } - dr = cutoff[m]-delta; - fwall = side * 2.0*epsilon[m]*dr; + dr = cutoff[m] - delta; + fwall = side * 2.0 * epsilon[m] * dr; f[i][dim] -= fwall; - ewall[0] += epsilon[m]*dr*dr; - ewall[m+1] += fwall; + ewall[0] += epsilon[m] * dr * dr; + ewall[m + 1] += fwall; if (evflag) { - if (side < 0) vn = -fwall*delta; - else vn = fwall*delta; - v_tally(dim,i,vn); + if (side < 0) + vn = -fwall * delta; + else + vn = fwall * delta; + v_tally(dim, i, vn); } } - if (onflag) error->one(FLERR,"Particle on or inside fix wall surface"); + if (onflag) error->one(FLERR, "Particle on or inside fix wall surface"); } diff --git a/src/fix_wall_morse.cpp b/src/fix_wall_morse.cpp index afac920c01..942e8e0e04 100644 --- a/src/fix_wall_morse.cpp +++ b/src/fix_wall_morse.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -13,17 +12,17 @@ ------------------------------------------------------------------------- */ #include "fix_wall_morse.h" -#include #include "atom.h" #include "error.h" +#include + using namespace LAMMPS_NS; using namespace FixConst; /* ---------------------------------------------------------------------- */ -FixWallMorse::FixWallMorse(LAMMPS *lmp, int narg, char **arg) : - FixWall(lmp, narg, arg) +FixWallMorse::FixWallMorse(LAMMPS *lmp, int narg, char **arg) : FixWall(lmp, narg, arg) { dynamic_group_allow = 1; } @@ -34,7 +33,7 @@ void FixWallMorse::precompute(int m) { coeff1[m] = 2.0 * epsilon[m] * alpha[m]; const double alpha_dr = -alpha[m] * (cutoff[m] - sigma[m]); - offset[m] = epsilon[m] * (exp(2.0*alpha_dr) - 2.0*exp(alpha_dr)); + offset[m] = epsilon[m] * (exp(2.0 * alpha_dr) - 2.0 * exp(alpha_dr)); } /* ---------------------------------------------------------------------- @@ -46,7 +45,7 @@ void FixWallMorse::precompute(int m) void FixWallMorse::wall_particle(int m, int which, double coord) { - double delta,fwall; + double delta, fwall; double vn; double **x = atom->x; @@ -62,8 +61,10 @@ void FixWallMorse::wall_particle(int m, int which, double coord) for (int i = 0; i < nlocal; i++) { if (mask[i] & groupbit) { - if (side < 0) delta = x[i][dim] - coord; - else delta = coord - x[i][dim]; + if (side < 0) + delta = x[i][dim] - coord; + else + delta = coord - x[i][dim]; if (delta >= cutoff[m]) continue; if (delta <= 0.0) { onflag = 1; @@ -71,18 +72,20 @@ void FixWallMorse::wall_particle(int m, int which, double coord) } double dr = delta - sigma[m]; double dexp = exp(-alpha[m] * dr); - fwall = side * coeff1[m] * (dexp*dexp - dexp) / delta; - ewall[0] += epsilon[m] * (dexp*dexp - 2.0*dexp) - offset[m]; + fwall = side * coeff1[m] * (dexp * dexp - dexp) / delta; + ewall[0] += epsilon[m] * (dexp * dexp - 2.0 * dexp) - offset[m]; f[i][dim] -= fwall; - ewall[m+1] += fwall; + ewall[m + 1] += fwall; if (evflag) { - if (side < 0) vn = -fwall*delta; - else vn = fwall*delta; + if (side < 0) + vn = -fwall * delta; + else + vn = fwall * delta; v_tally(dim, i, vn); } } } - if (onflag) error->one(FLERR,"Particle on or inside fix wall surface"); + if (onflag) error->one(FLERR, "Particle on or inside fix wall surface"); } diff --git a/src/npair_copy.cpp b/src/npair_copy.cpp index b3cab53e0a..38a36d0ba5 100644 --- a/src/npair_copy.cpp +++ b/src/npair_copy.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories diff --git a/src/npair_full_bin_atomonly.cpp b/src/npair_full_bin_atomonly.cpp index b8c4378280..aa7a91dbbe 100644 --- a/src/npair_full_bin_atomonly.cpp +++ b/src/npair_full_bin_atomonly.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -32,8 +31,8 @@ NPairFullBinAtomonly::NPairFullBinAtomonly(LAMMPS *lmp) : NPair(lmp) {} void NPairFullBinAtomonly::build(NeighList *list) { - int i,j,k,n,itype,jtype,ibin; - double xtmp,ytmp,ztmp,delx,dely,delz,rsq; + int i, j, k, n, itype, jtype, ibin; + double xtmp, ytmp, ztmp, delx, dely, delz, rsq; int *neighptr; double **x = atom->x; @@ -66,16 +65,16 @@ void NPairFullBinAtomonly::build(NeighList *list) ibin = atom2bin[i]; for (k = 0; k < nstencil; k++) { - for (j = binhead[ibin+stencil[k]]; j >= 0; j = bins[j]) { + for (j = binhead[ibin + stencil[k]]; j >= 0; j = bins[j]) { if (i == j) continue; jtype = type[j]; - if (exclude && exclusion(i,j,itype,jtype,mask,molecule)) continue; + if (exclude && exclusion(i, j, itype, jtype, mask, molecule)) continue; delx = xtmp - x[j][0]; dely = ytmp - x[j][1]; delz = ztmp - x[j][2]; - rsq = delx*delx + dely*dely + delz*delz; + rsq = delx * delx + dely * dely + delz * delz; if (rsq <= cutneighsq[itype][jtype]) neighptr[n++] = j; } @@ -85,8 +84,7 @@ void NPairFullBinAtomonly::build(NeighList *list) firstneigh[i] = neighptr; numneigh[i] = n; ipage->vgot(n); - if (ipage->status()) - error->one(FLERR,"Neighbor list overflow, boost neigh_modify one"); + if (ipage->status()) error->one(FLERR, "Neighbor list overflow, boost neigh_modify one"); } list->inum = inum; diff --git a/src/npair_halffull_newtoff.cpp b/src/npair_halffull_newtoff.cpp index 475325c2f0..57c121b933 100644 --- a/src/npair_halffull_newtoff.cpp +++ b/src/npair_halffull_newtoff.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -35,8 +34,8 @@ NPairHalffullNewtoff::NPairHalffullNewtoff(LAMMPS *lmp) : NPair(lmp) {} void NPairHalffullNewtoff::build(NeighList *list) { - int i,j,ii,jj,n,jnum,joriginal; - int *neighptr,*jlist; + int i, j, ii, jj, n, jnum, joriginal; + int *neighptr, *jlist; int *ilist = list->ilist; int *numneigh = list->numneigh; @@ -74,8 +73,7 @@ void NPairHalffullNewtoff::build(NeighList *list) firstneigh[i] = neighptr; numneigh[i] = n; ipage->vgot(n); - if (ipage->status()) - error->one(FLERR,"Neighbor list overflow, boost neigh_modify one"); + if (ipage->status()) error->one(FLERR, "Neighbor list overflow, boost neigh_modify one"); } list->inum = inum; diff --git a/src/npair_skip_size.cpp b/src/npair_skip_size.cpp index f4fe760e08..b0134fd82c 100644 --- a/src/npair_skip_size.cpp +++ b/src/npair_skip_size.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -32,8 +31,8 @@ NPairSkipSize::NPairSkipSize(LAMMPS *lmp) : NPair(lmp) {} void NPairSkipSize::build(NeighList *list) { - int i,j,ii,jj,n,itype,jnum,joriginal; - int *neighptr,*jlist; + int i, j, ii, jj, n, itype, jnum, joriginal; + int *neighptr, *jlist; int *type = atom->type; int *ilist = list->ilist; @@ -80,8 +79,7 @@ void NPairSkipSize::build(NeighList *list) firstneigh[i] = neighptr; numneigh[i] = n; ipage->vgot(n); - if (ipage->status()) - error->one(FLERR,"Neighbor list overflow, boost neigh_modify one"); + if (ipage->status()) error->one(FLERR, "Neighbor list overflow, boost neigh_modify one"); } list->inum = inum; diff --git a/src/nstencil_full_bin_2d.cpp b/src/nstencil_full_bin_2d.cpp index ba4ca97ed6..5c79f3ae8a 100644 --- a/src/nstencil_full_bin_2d.cpp +++ b/src/nstencil_full_bin_2d.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -26,12 +25,11 @@ NStencilFullBin2d::NStencilFullBin2d(LAMMPS *lmp) : NStencil(lmp) {} void NStencilFullBin2d::create() { - int i,j; + int i, j; nstencil = 0; for (j = -sy; j <= sy; j++) for (i = -sx; i <= sx; i++) - if (bin_distance(i,j,0) < cutneighmaxsq) - stencil[nstencil++] = j*mbinx + i; + if (bin_distance(i, j, 0) < cutneighmaxsq) stencil[nstencil++] = j * mbinx + i; } diff --git a/src/nstencil_full_bin_3d.cpp b/src/nstencil_full_bin_3d.cpp index 8aa593eb0b..837bf109f2 100644 --- a/src/nstencil_full_bin_3d.cpp +++ b/src/nstencil_full_bin_3d.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -26,13 +25,13 @@ NStencilFullBin3d::NStencilFullBin3d(LAMMPS *lmp) : NStencil(lmp) {} void NStencilFullBin3d::create() { - int i,j,k; + int i, j, k; nstencil = 0; for (k = -sz; k <= sz; k++) for (j = -sy; j <= sy; j++) for (i = -sx; i <= sx; i++) - if (bin_distance(i,j,k) < cutneighmaxsq) - stencil[nstencil++] = k*mbiny*mbinx + j*mbinx + i; + if (bin_distance(i, j, k) < cutneighmaxsq) + stencil[nstencil++] = k * mbiny * mbinx + j * mbinx + i; } diff --git a/src/nstencil_full_ghost_bin_2d.cpp b/src/nstencil_full_ghost_bin_2d.cpp index b5a6bac56c..32c4440647 100644 --- a/src/nstencil_full_ghost_bin_2d.cpp +++ b/src/nstencil_full_ghost_bin_2d.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -29,16 +28,16 @@ NStencilFullGhostBin2d::NStencilFullGhostBin2d(LAMMPS *lmp) : NStencil(lmp) void NStencilFullGhostBin2d::create() { - int i,j; + int i, j; nstencil = 0; for (j = -sy; j <= sy; j++) for (i = -sx; i <= sx; i++) - if (bin_distance(i,j,0) < cutneighmaxsq) { + if (bin_distance(i, j, 0) < cutneighmaxsq) { stencilxyz[nstencil][0] = i; stencilxyz[nstencil][1] = j; stencilxyz[nstencil][2] = 0; - stencil[nstencil++] = j*mbinx + i; + stencil[nstencil++] = j * mbinx + i; } } diff --git a/src/nstencil_full_ghost_bin_3d.cpp b/src/nstencil_full_ghost_bin_3d.cpp index 2023495c34..3d43e35e04 100644 --- a/src/nstencil_full_ghost_bin_3d.cpp +++ b/src/nstencil_full_ghost_bin_3d.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -29,17 +28,17 @@ NStencilFullGhostBin3d::NStencilFullGhostBin3d(LAMMPS *lmp) : NStencil(lmp) void NStencilFullGhostBin3d::create() { - int i,j,k; + int i, j, k; nstencil = 0; for (k = -sz; k <= sz; k++) for (j = -sy; j <= sy; j++) for (i = -sx; i <= sx; i++) - if (bin_distance(i,j,k) < cutneighmaxsq) { + if (bin_distance(i, j, k) < cutneighmaxsq) { stencilxyz[nstencil][0] = i; stencilxyz[nstencil][1] = j; stencilxyz[nstencil][2] = k; - stencil[nstencil++] = k*mbiny*mbinx + j*mbinx + i; + stencil[nstencil++] = k * mbiny * mbinx + j * mbinx + i; } } diff --git a/src/nstencil_full_multi_2d.cpp b/src/nstencil_full_multi_2d.cpp index 52ae88d09e..d6e5fd2a9d 100644 --- a/src/nstencil_full_multi_2d.cpp +++ b/src/nstencil_full_multi_2d.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -50,7 +49,6 @@ void NStencilFullMulti2d::create() int n = ncollections; double cutsq; - for (icollection = 0; icollection < n; icollection++) { for (jcollection = 0; jcollection < n; jcollection++) { if (flag_skip_multi[icollection][jcollection]) { @@ -72,8 +70,8 @@ void NStencilFullMulti2d::create() for (j = -sy; j <= sy; j++) for (i = -sx; i <= sx; i++) - if (bin_distance_multi(i,j,0,bin_collection) < cutsq) - stencil_multi[icollection][jcollection][ns++] = j*mbinx + i; + if (bin_distance_multi(i, j, 0, bin_collection) < cutsq) + stencil_multi[icollection][jcollection][ns++] = j * mbinx + i; nstencil_multi[icollection][jcollection] = ns; } diff --git a/src/nstencil_full_multi_old_2d.cpp b/src/nstencil_full_multi_old_2d.cpp index d653e1080e..3747e99699 100644 --- a/src/nstencil_full_multi_old_2d.cpp +++ b/src/nstencil_full_multi_old_2d.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -27,8 +26,8 @@ NStencilFullMultiOld2d::NStencilFullMultiOld2d(LAMMPS *lmp) : NStencil(lmp) {} void NStencilFullMultiOld2d::create() { - int i,j,n; - double rsq,typesq; + int i, j, n; + double rsq, typesq; int *s; double *distsq; @@ -40,10 +39,10 @@ void NStencilFullMultiOld2d::create() n = 0; for (j = -sy; j <= sy; j++) for (i = -sx; i <= sx; i++) { - rsq = bin_distance(i,j,0); + rsq = bin_distance(i, j, 0); if (rsq < typesq) { distsq[n] = rsq; - s[n++] = j*mbinx + i; + s[n++] = j * mbinx + i; } } nstencil_multi_old[itype] = n; diff --git a/src/nstencil_full_multi_old_3d.cpp b/src/nstencil_full_multi_old_3d.cpp index 849ee5a9f9..04f10c5362 100644 --- a/src/nstencil_full_multi_old_3d.cpp +++ b/src/nstencil_full_multi_old_3d.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -27,8 +26,8 @@ NStencilFullMultiOld3d::NStencilFullMultiOld3d(LAMMPS *lmp) : NStencil(lmp) {} void NStencilFullMultiOld3d::create() { - int i,j,k,n; - double rsq,typesq; + int i, j, k, n; + double rsq, typesq; int *s; double *distsq; @@ -41,10 +40,10 @@ void NStencilFullMultiOld3d::create() for (k = -sz; k <= sz; k++) for (j = -sy; j <= sy; j++) for (i = -sx; i <= sx; i++) { - rsq = bin_distance(i,j,k); + rsq = bin_distance(i, j, k); if (rsq < typesq) { distsq[n] = rsq; - s[n++] = k*mbiny*mbinx + j*mbinx + i; + s[n++] = k * mbiny * mbinx + j * mbinx + i; } } nstencil_multi_old[itype] = n; diff --git a/src/nstencil_half_bin_2d.cpp b/src/nstencil_half_bin_2d.cpp index 004d6a8016..b1ad0237a7 100644 --- a/src/nstencil_half_bin_2d.cpp +++ b/src/nstencil_half_bin_2d.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -26,13 +25,12 @@ NStencilHalfBin2d::NStencilHalfBin2d(LAMMPS *lmp) : NStencil(lmp) {} void NStencilHalfBin2d::create() { - int i,j; + int i, j; nstencil = 0; for (j = 0; j <= sy; j++) for (i = -sx; i <= sx; i++) if (j > 0 || (j == 0 && i > 0)) - if (bin_distance(i,j,0) < cutneighmaxsq) - stencil[nstencil++] = j*mbinx + i; + if (bin_distance(i, j, 0) < cutneighmaxsq) stencil[nstencil++] = j * mbinx + i; } diff --git a/src/nstencil_half_bin_2d_tri.cpp b/src/nstencil_half_bin_2d_tri.cpp index 9f5ace1ed1..7b7ce962a2 100644 --- a/src/nstencil_half_bin_2d_tri.cpp +++ b/src/nstencil_half_bin_2d_tri.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -18,8 +17,7 @@ using namespace LAMMPS_NS; /* ---------------------------------------------------------------------- */ -NStencilHalfBin2dTri::NStencilHalfBin2dTri(LAMMPS *lmp) : - NStencil(lmp) {} +NStencilHalfBin2dTri::NStencilHalfBin2dTri(LAMMPS *lmp) : NStencil(lmp) {} /* ---------------------------------------------------------------------- create stencil based on bin geometry and cutoff @@ -27,12 +25,11 @@ NStencilHalfBin2dTri::NStencilHalfBin2dTri(LAMMPS *lmp) : void NStencilHalfBin2dTri::create() { - int i,j; + int i, j; nstencil = 0; for (j = 0; j <= sy; j++) for (i = -sx; i <= sx; i++) - if (bin_distance(i,j,0) < cutneighmaxsq) - stencil[nstencil++] = j*mbinx + i; + if (bin_distance(i, j, 0) < cutneighmaxsq) stencil[nstencil++] = j * mbinx + i; } diff --git a/src/nstencil_half_bin_3d.cpp b/src/nstencil_half_bin_3d.cpp index a8cacdb601..736bf151ee 100644 --- a/src/nstencil_half_bin_3d.cpp +++ b/src/nstencil_half_bin_3d.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -26,7 +25,7 @@ NStencilHalfBin3d::NStencilHalfBin3d(LAMMPS *lmp) : NStencil(lmp) {} void NStencilHalfBin3d::create() { - int i,j,k; + int i, j, k; nstencil = 0; @@ -34,6 +33,6 @@ void NStencilHalfBin3d::create() for (j = -sy; j <= sy; j++) for (i = -sx; i <= sx; i++) if (k > 0 || j > 0 || (j == 0 && i > 0)) - if (bin_distance(i,j,k) < cutneighmaxsq) - stencil[nstencil++] = k*mbiny*mbinx + j*mbinx + i; + if (bin_distance(i, j, k) < cutneighmaxsq) + stencil[nstencil++] = k * mbiny * mbinx + j * mbinx + i; } diff --git a/src/nstencil_half_bin_3d_tri.cpp b/src/nstencil_half_bin_3d_tri.cpp index 8d1920ae8c..a5376d0208 100644 --- a/src/nstencil_half_bin_3d_tri.cpp +++ b/src/nstencil_half_bin_3d_tri.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -18,8 +17,7 @@ using namespace LAMMPS_NS; /* ---------------------------------------------------------------------- */ -NStencilHalfBin3dTri::NStencilHalfBin3dTri(LAMMPS *lmp) : - NStencil(lmp) {} +NStencilHalfBin3dTri::NStencilHalfBin3dTri(LAMMPS *lmp) : NStencil(lmp) {} /* ---------------------------------------------------------------------- create stencil based on bin geometry and cutoff @@ -27,13 +25,13 @@ NStencilHalfBin3dTri::NStencilHalfBin3dTri(LAMMPS *lmp) : void NStencilHalfBin3dTri::create() { - int i,j,k; + int i, j, k; nstencil = 0; for (k = 0; k <= sz; k++) for (j = -sy; j <= sy; j++) for (i = -sx; i <= sx; i++) - if (bin_distance(i,j,k) < cutneighmaxsq) - stencil[nstencil++] = k*mbiny*mbinx + j*mbinx + i; + if (bin_distance(i, j, k) < cutneighmaxsq) + stencil[nstencil++] = k * mbiny * mbinx + j * mbinx + i; } diff --git a/src/nstencil_half_multi_old_2d.cpp b/src/nstencil_half_multi_old_2d.cpp index 7a2f5a25e2..b4869b37f4 100644 --- a/src/nstencil_half_multi_old_2d.cpp +++ b/src/nstencil_half_multi_old_2d.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -19,8 +18,7 @@ using namespace LAMMPS_NS; /* ---------------------------------------------------------------------- */ -NStencilHalfMultiOld2d:: -NStencilHalfMultiOld2d(LAMMPS *lmp) : NStencil(lmp) {} +NStencilHalfMultiOld2d::NStencilHalfMultiOld2d(LAMMPS *lmp) : NStencil(lmp) {} /* ---------------------------------------------------------------------- create stencil based on bin geometry and cutoff @@ -28,8 +26,8 @@ NStencilHalfMultiOld2d(LAMMPS *lmp) : NStencil(lmp) {} void NStencilHalfMultiOld2d::create() { - int i,j,n; - double rsq,typesq; + int i, j, n; + double rsq, typesq; int *s; double *distsq; @@ -42,10 +40,10 @@ void NStencilHalfMultiOld2d::create() for (j = 0; j <= sy; j++) for (i = -sx; i <= sx; i++) if (j > 0 || (j == 0 && i > 0)) { - rsq = bin_distance(i,j,0); + rsq = bin_distance(i, j, 0); if (rsq < typesq) { distsq[n] = rsq; - s[n++] = j*mbinx + i; + s[n++] = j * mbinx + i; } } nstencil_multi_old[itype] = n; diff --git a/src/nstencil_half_multi_old_2d_tri.cpp b/src/nstencil_half_multi_old_2d_tri.cpp index 7e5158cc31..e6cf2d311e 100644 --- a/src/nstencil_half_multi_old_2d_tri.cpp +++ b/src/nstencil_half_multi_old_2d_tri.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -19,8 +18,7 @@ using namespace LAMMPS_NS; /* ---------------------------------------------------------------------- */ -NStencilHalfMultiOld2dTri:: -NStencilHalfMultiOld2dTri(LAMMPS *lmp) : NStencil(lmp) {} +NStencilHalfMultiOld2dTri::NStencilHalfMultiOld2dTri(LAMMPS *lmp) : NStencil(lmp) {} /* ---------------------------------------------------------------------- create stencil based on bin geometry and cutoff @@ -28,8 +26,8 @@ NStencilHalfMultiOld2dTri(LAMMPS *lmp) : NStencil(lmp) {} void NStencilHalfMultiOld2dTri::create() { - int i,j,n; - double rsq,typesq; + int i, j, n; + double rsq, typesq; int *s; double *distsq; @@ -41,10 +39,10 @@ void NStencilHalfMultiOld2dTri::create() n = 0; for (j = 0; j <= sy; j++) for (i = -sx; i <= sx; i++) { - rsq = bin_distance(i,j,0); + rsq = bin_distance(i, j, 0); if (rsq < typesq) { distsq[n] = rsq; - s[n++] = j*mbinx + i; + s[n++] = j * mbinx + i; } } nstencil_multi_old[itype] = n; diff --git a/src/nstencil_half_multi_old_3d.cpp b/src/nstencil_half_multi_old_3d.cpp index cdb22c2d13..ada8c66610 100644 --- a/src/nstencil_half_multi_old_3d.cpp +++ b/src/nstencil_half_multi_old_3d.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -19,8 +18,7 @@ using namespace LAMMPS_NS; /* ---------------------------------------------------------------------- */ -NStencilHalfMultiOld3d:: -NStencilHalfMultiOld3d(LAMMPS *lmp) : NStencil(lmp) {} +NStencilHalfMultiOld3d::NStencilHalfMultiOld3d(LAMMPS *lmp) : NStencil(lmp) {} /* ---------------------------------------------------------------------- create stencil based on bin geometry and cutoff @@ -28,8 +26,8 @@ NStencilHalfMultiOld3d(LAMMPS *lmp) : NStencil(lmp) {} void NStencilHalfMultiOld3d::create() { - int i,j,k,n; - double rsq,typesq; + int i, j, k, n; + double rsq, typesq; int *s; double *distsq; @@ -43,10 +41,10 @@ void NStencilHalfMultiOld3d::create() for (j = -sy; j <= sy; j++) for (i = -sx; i <= sx; i++) if (k > 0 || j > 0 || (j == 0 && i > 0)) { - rsq = bin_distance(i,j,k); + rsq = bin_distance(i, j, k); if (rsq < typesq) { distsq[n] = rsq; - s[n++] = k*mbiny*mbinx + j*mbinx + i; + s[n++] = k * mbiny * mbinx + j * mbinx + i; } } nstencil_multi_old[itype] = n; diff --git a/src/nstencil_half_multi_old_3d_tri.cpp b/src/nstencil_half_multi_old_3d_tri.cpp index 6fb9b6d3d1..c58fe509ef 100644 --- a/src/nstencil_half_multi_old_3d_tri.cpp +++ b/src/nstencil_half_multi_old_3d_tri.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -19,8 +18,7 @@ using namespace LAMMPS_NS; /* ---------------------------------------------------------------------- */ -NStencilHalfMultiOld3dTri:: -NStencilHalfMultiOld3dTri(LAMMPS *lmp) : NStencil(lmp) {} +NStencilHalfMultiOld3dTri::NStencilHalfMultiOld3dTri(LAMMPS *lmp) : NStencil(lmp) {} /* ---------------------------------------------------------------------- create stencil based on bin geometry and cutoff @@ -28,8 +26,8 @@ NStencilHalfMultiOld3dTri(LAMMPS *lmp) : NStencil(lmp) {} void NStencilHalfMultiOld3dTri::create() { - int i,j,k,n; - double rsq,typesq; + int i, j, k, n; + double rsq, typesq; int *s; double *distsq; @@ -42,10 +40,10 @@ void NStencilHalfMultiOld3dTri::create() for (k = 0; k <= sz; k++) for (j = -sy; j <= sy; j++) for (i = -sx; i <= sx; i++) { - rsq = bin_distance(i,j,k); + rsq = bin_distance(i, j, k); if (rsq < typesq) { distsq[n] = rsq; - s[n++] = k*mbiny*mbinx + j*mbinx + i; + s[n++] = k * mbiny * mbinx + j * mbinx + i; } } nstencil_multi_old[itype] = n; diff --git a/src/ntopo_bond_all.cpp b/src/ntopo_bond_all.cpp index ab397cab7b..b3cd3011a5 100644 --- a/src/ntopo_bond_all.cpp +++ b/src/ntopo_bond_all.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -15,14 +14,13 @@ #include "ntopo_bond_all.h" #include "atom.h" -#include "force.h" #include "domain.h" -#include "update.h" +#include "error.h" +#include "force.h" +#include "memory.h" #include "output.h" #include "thermo.h" -#include "memory.h" -#include "error.h" - +#include "update.h" using namespace LAMMPS_NS; @@ -39,7 +37,7 @@ NTopoBondAll::NTopoBondAll(LAMMPS *lmp) : NTopo(lmp) void NTopoBondAll::build() { - int i,m,atom1; + int i, m, atom1; int nlocal = atom->nlocal; int *num_bond = atom->num_bond; @@ -58,16 +56,17 @@ void NTopoBondAll::build() if (atom1 == -1) { nmissing++; if (lostbond == Thermo::ERROR) - error->one(FLERR,"Bond atoms {} {} missing on " - "proc {} at step {}",tag[i], - bond_atom[i][m],me,update->ntimestep); + error->one(FLERR, + "Bond atoms {} {} missing on " + "proc {} at step {}", + tag[i], bond_atom[i][m], me, update->ntimestep); continue; } - atom1 = domain->closest_image(i,atom1); + atom1 = domain->closest_image(i, atom1); if (newton_bond || i < atom1) { if (nbondlist == maxbond) { maxbond += DELTA; - memory->grow(bondlist,maxbond,3,"neigh_topo:bondlist"); + memory->grow(bondlist, maxbond, 3, "neigh_topo:bondlist"); } bondlist[nbondlist][0] = i; bondlist[nbondlist][1] = atom1; @@ -80,7 +79,6 @@ void NTopoBondAll::build() if (lostbond == Thermo::IGNORE) return; int all; - MPI_Allreduce(&nmissing,&all,1,MPI_INT,MPI_SUM,world); - if (all && (me == 0)) - error->warning(FLERR,"Bond atoms missing at step {}",update->ntimestep); + MPI_Allreduce(&nmissing, &all, 1, MPI_INT, MPI_SUM, world); + if (all && (me == 0)) error->warning(FLERR, "Bond atoms missing at step {}", update->ntimestep); } diff --git a/src/ntopo_bond_partial.cpp b/src/ntopo_bond_partial.cpp index 851703776b..de6d0bf151 100644 --- a/src/ntopo_bond_partial.cpp +++ b/src/ntopo_bond_partial.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -15,14 +14,13 @@ #include "ntopo_bond_partial.h" #include "atom.h" -#include "force.h" #include "domain.h" -#include "update.h" +#include "error.h" +#include "force.h" +#include "memory.h" #include "output.h" #include "thermo.h" -#include "memory.h" -#include "error.h" - +#include "update.h" using namespace LAMMPS_NS; @@ -39,7 +37,7 @@ NTopoBondPartial::NTopoBondPartial(LAMMPS *lmp) : NTopo(lmp) void NTopoBondPartial::build() { - int i,m,atom1; + int i, m, atom1; int nlocal = atom->nlocal; int *num_bond = atom->num_bond; @@ -59,16 +57,17 @@ void NTopoBondPartial::build() if (atom1 == -1) { nmissing++; if (lostbond == Thermo::ERROR) - error->one(FLERR,"Bond atoms {} {} missing on " - "proc {} at step {}",tag[i], - bond_atom[i][m],me,update->ntimestep); + error->one(FLERR, + "Bond atoms {} {} missing on " + "proc {} at step {}", + tag[i], bond_atom[i][m], me, update->ntimestep); continue; } - atom1 = domain->closest_image(i,atom1); + atom1 = domain->closest_image(i, atom1); if (newton_bond || i < atom1) { if (nbondlist == maxbond) { maxbond += DELTA; - memory->grow(bondlist,maxbond,3,"neigh_topo:bondlist"); + memory->grow(bondlist, maxbond, 3, "neigh_topo:bondlist"); } bondlist[nbondlist][0] = i; bondlist[nbondlist][1] = atom1; @@ -81,7 +80,6 @@ void NTopoBondPartial::build() if (lostbond == Thermo::IGNORE) return; int all; - MPI_Allreduce(&nmissing,&all,1,MPI_INT,MPI_SUM,world); - if (all && (me == 0)) - error->warning(FLERR,"Bond atoms missing at step {}",update->ntimestep); + MPI_Allreduce(&nmissing, &all, 1, MPI_INT, MPI_SUM, world); + if (all && (me == 0)) error->warning(FLERR, "Bond atoms missing at step {}", update->ntimestep); } diff --git a/src/reader.cpp b/src/reader.cpp index eb8cd9ffb6..c7b99260e7 100644 --- a/src/reader.cpp +++ b/src/reader.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -41,19 +40,19 @@ void Reader::open_file(const std::string &file) if (platform::has_compress_extension(file)) { compressed = true; fp = platform::compressed_read(file); - if (!fp) error->one(FLERR,"Cannot open compressed file for reading"); + if (!fp) error->one(FLERR, "Cannot open compressed file for reading"); } else { compressed = false; if (utils::strmatch(file, "\\.bin$")) { binary = true; - fp = fopen(file.c_str(),"rb"); + fp = fopen(file.c_str(), "rb"); } else { - fp = fopen(file.c_str(),"r"); + fp = fopen(file.c_str(), "r"); binary = false; } } - if (!fp) error->one(FLERR,"Cannot open file {}: {}", file, utils::getsyserror()); + if (!fp) error->one(FLERR, "Cannot open file {}: {}", file, utils::getsyserror()); } /* ---------------------------------------------------------------------- @@ -64,8 +63,10 @@ void Reader::open_file(const std::string &file) void Reader::close_file() { if (fp == nullptr) return; - if (compressed) platform::pclose(fp); - else fclose(fp); + if (compressed) + platform::pclose(fp); + else + fclose(fp); fp = nullptr; } @@ -73,8 +74,7 @@ void Reader::close_file() detect unused arguments ------------------------------------------------------------------------- */ -void Reader::settings(int narg, char** /*args*/) +void Reader::settings(int narg, char ** /*args*/) { - if (narg > 0) - error->all(FLERR,"Illegal read_dump command"); + if (narg > 0) error->all(FLERR, "Illegal read_dump command"); } diff --git a/src/write_dump.cpp b/src/write_dump.cpp index e9f610fe31..2ce28f01e4 100644 --- a/src/write_dump.cpp +++ b/src/write_dump.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -34,41 +33,39 @@ using namespace LAMMPS_NS; void WriteDump::command(int narg, char **arg) { - if (narg < 3) error->all(FLERR,"Illegal write_dump command"); + if (narg < 3) error->all(FLERR, "Illegal write_dump command"); // modindex = index in args of "modify" keyword // will be narg if "modify" is not present int modindex; for (modindex = 0; modindex < narg; modindex++) - if (strcmp(arg[modindex],"modify") == 0) break; + if (strcmp(arg[modindex], "modify") == 0) break; // create the Dump instance // create dump command line with extra required args - auto dumpargs = new char*[modindex+2]; - dumpargs[0] = (char *) "WRITE_DUMP"; // dump id - dumpargs[1] = arg[0]; // group - dumpargs[2] = arg[1]; // dump style - std::string ntimestep = std::to_string(MAX(update->ntimestep,1)); - dumpargs[3] = (char *) ntimestep.c_str(); // dump frequency + auto dumpargs = new char *[modindex + 2]; + dumpargs[0] = (char *) "WRITE_DUMP"; // dump id + dumpargs[1] = arg[0]; // group + dumpargs[2] = arg[1]; // dump style + std::string ntimestep = std::to_string(MAX(update->ntimestep, 1)); + dumpargs[3] = (char *) ntimestep.c_str(); // dump frequency - for (int i = 2; i < modindex; ++i) dumpargs[i+2] = arg[i]; + for (int i = 2; i < modindex; ++i) dumpargs[i + 2] = arg[i]; - Dump *dump = output->add_dump(modindex+2, dumpargs); - if (modindex < narg) dump->modify_params(narg-modindex-1,&arg[modindex+1]); + Dump *dump = output->add_dump(modindex + 2, dumpargs); + if (modindex < narg) dump->modify_params(narg - modindex - 1, &arg[modindex + 1]); // write out one frame and then delete the dump again // set multifile_override for DumpImage so that filename needs no "*" - if (strcmp(arg[1],"image") == 0) - (dynamic_cast( dump))->multifile_override = 1; + if (strcmp(arg[1], "image") == 0) (dynamic_cast(dump))->multifile_override = 1; - if (strcmp(arg[1],"cfg") == 0) - (dynamic_cast( dump))->multifile_override = 1; + if (strcmp(arg[1], "cfg") == 0) (dynamic_cast(dump))->multifile_override = 1; if ((update->first_update == 0) && (comm->me == 0)) - error->warning(FLERR,"Calling write_dump before a full system init."); + error->warning(FLERR, "Calling write_dump before a full system init."); dump->init(); dump->write(); From 7d3d986d184437bb242fb384ac249ae4d3decce0 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sun, 22 May 2022 14:03:20 -0400 Subject: [PATCH 190/585] download, build, and link a missing jpeg library with CMake --- cmake/CMakeLists.libjpeg | 1482 ++++++++++++++++++++++++++++++++++++++ cmake/CMakeLists.txt | 16 +- 2 files changed, 1497 insertions(+), 1 deletion(-) create mode 100644 cmake/CMakeLists.libjpeg diff --git a/cmake/CMakeLists.libjpeg b/cmake/CMakeLists.libjpeg new file mode 100644 index 0000000000..f03eba40aa --- /dev/null +++ b/cmake/CMakeLists.libjpeg @@ -0,0 +1,1482 @@ +cmake_minimum_required(VERSION 3.10) +# When using CMake 3.4 and later, don't export symbols from executables unless +# the CMAKE_ENABLE_EXPORTS variable is set. +if(POLICY CMP0065) + cmake_policy(SET CMP0065 NEW) +endif() +if (POLICY CMP0077) + cmake_policy(SET CMP0077 NEW) +endif() +if(CMAKE_EXECUTABLE_SUFFIX) + set(CMAKE_EXECUTABLE_SUFFIX_TMP ${CMAKE_EXECUTABLE_SUFFIX}) +endif() + +project(libjpeg-turbo C) +set(VERSION 2.1.3) +set(COPYRIGHT_YEAR "1991-2022") +string(REPLACE "." ";" VERSION_TRIPLET ${VERSION}) +list(GET VERSION_TRIPLET 0 VERSION_MAJOR) +list(GET VERSION_TRIPLET 1 VERSION_MINOR) +list(GET VERSION_TRIPLET 2 VERSION_REVISION) +function(pad_number NUMBER OUTPUT_LEN) + string(LENGTH "${${NUMBER}}" INPUT_LEN) + if(INPUT_LEN LESS OUTPUT_LEN) + math(EXPR ZEROES "${OUTPUT_LEN} - ${INPUT_LEN} - 1") + set(NUM ${${NUMBER}}) + foreach(C RANGE ${ZEROES}) + set(NUM "0${NUM}") + endforeach() + set(${NUMBER} ${NUM} PARENT_SCOPE) + endif() +endfunction() +pad_number(VERSION_MINOR 3) +pad_number(VERSION_REVISION 3) +set(LIBJPEG_TURBO_VERSION_NUMBER ${VERSION_MAJOR}${VERSION_MINOR}${VERSION_REVISION}) + +# CMake 3.14 and later sets CMAKE_MACOSX_BUNDLE to TRUE by default when +# CMAKE_SYSTEM_NAME is iOS, tvOS, or watchOS, which breaks the libjpeg-turbo +# build. (Specifically, when CMAKE_MACOSX_BUNDLE is TRUE, executables for +# Apple platforms are built as application bundles, which causes CMake to +# complain that our install() directives for executables do not specify a +# BUNDLE DESTINATION. Even if CMake did not complain, building executables as +# application bundles would break our iOS packages.) +set(CMAKE_MACOSX_BUNDLE FALSE) + +string(TIMESTAMP DEFAULT_BUILD "%Y%m%d") +set(BUILD ${DEFAULT_BUILD} CACHE STRING "Build string (default: ${DEFAULT_BUILD})") + +# NOTE: On Windows, this does nothing except when using MinGW or Cygwin. +# CMAKE_BUILD_TYPE has no meaning in Visual Studio, and it always defaults to +# Debug when using NMake. +if(NOT CMAKE_BUILD_TYPE) + set(CMAKE_BUILD_TYPE Release) +endif() +message(STATUS "CMAKE_BUILD_TYPE = ${CMAKE_BUILD_TYPE}") + +message(STATUS "VERSION = ${VERSION}, BUILD = ${BUILD}") + +include(cmakescripts/PackageInfo.cmake) + +# Detect CPU type and whether we're building 64-bit or 32-bit code +math(EXPR BITS "${CMAKE_SIZEOF_VOID_P} * 8") +string(TOLOWER ${CMAKE_SYSTEM_PROCESSOR} CMAKE_SYSTEM_PROCESSOR_LC) +set(COUNT 1) +foreach(ARCH ${CMAKE_OSX_ARCHITECTURES}) + if(COUNT GREATER 1) + message(FATAL_ERROR "The libjpeg-turbo build system does not support multiple values in CMAKE_OSX_ARCHITECTURES.") + endif() + math(EXPR COUNT "${COUNT}+1") +endforeach() +if(CMAKE_SYSTEM_PROCESSOR_LC MATCHES "x86_64" OR + CMAKE_SYSTEM_PROCESSOR_LC MATCHES "amd64" OR + CMAKE_SYSTEM_PROCESSOR_LC MATCHES "i[0-9]86" OR + CMAKE_SYSTEM_PROCESSOR_LC MATCHES "x86" OR + CMAKE_SYSTEM_PROCESSOR_LC MATCHES "ia32") + if(BITS EQUAL 64 OR CMAKE_C_COMPILER_ABI MATCHES "ELF X32") + set(CPU_TYPE x86_64) + else() + set(CPU_TYPE i386) + endif() + if(NOT CMAKE_SYSTEM_PROCESSOR STREQUAL ${CPU_TYPE}) + set(CMAKE_SYSTEM_PROCESSOR ${CPU_TYPE}) + endif() +elseif(CMAKE_SYSTEM_PROCESSOR_LC STREQUAL "aarch64" OR + CMAKE_SYSTEM_PROCESSOR_LC MATCHES "^arm") + if(BITS EQUAL 64) + set(CPU_TYPE arm64) + else() + set(CPU_TYPE arm) + endif() +elseif(CMAKE_SYSTEM_PROCESSOR_LC MATCHES "^ppc" OR + CMAKE_SYSTEM_PROCESSOR_LC MATCHES "^powerpc") + set(CPU_TYPE powerpc) +else() + set(CPU_TYPE ${CMAKE_SYSTEM_PROCESSOR_LC}) +endif() +if(CMAKE_OSX_ARCHITECTURES MATCHES "x86_64" OR + CMAKE_OSX_ARCHITECTURES MATCHES "arm64" OR + CMAKE_OSX_ARCHITECTURES MATCHES "i386") + set(CPU_TYPE ${CMAKE_OSX_ARCHITECTURES}) +endif() +if(CMAKE_OSX_ARCHITECTURES MATCHES "ppc") + set(CPU_TYPE powerpc) +endif() +if(MSVC_IDE AND CMAKE_GENERATOR_PLATFORM MATCHES "arm64") + set(CPU_TYPE arm64) +endif() + +message(STATUS "${BITS}-bit build (${CPU_TYPE})") + +macro(report_directory var) + if(CMAKE_INSTALL_${var} STREQUAL CMAKE_INSTALL_FULL_${var}) + message(STATUS "CMAKE_INSTALL_${var} = ${CMAKE_INSTALL_${var}}") + else() + message(STATUS "CMAKE_INSTALL_${var} = ${CMAKE_INSTALL_${var}} (${CMAKE_INSTALL_FULL_${var}})") + endif() + mark_as_advanced(CLEAR CMAKE_INSTALL_${var}) +endmacro() + +set(DIRLIST "BINDIR;DATAROOTDIR;DOCDIR;INCLUDEDIR;LIBDIR") +if(UNIX) + list(APPEND DIRLIST "MANDIR") +endif() +foreach(dir ${DIRLIST}) + report_directory(${dir}) +endforeach() + + +############################################################################### +# CONFIGURATION OPTIONS +############################################################################### + +macro(boolean_number var) + if(${var}) + set(${var} 1 ${ARGN}) + else() + set(${var} 0 ${ARGN}) + endif() +endmacro() + +option(ENABLE_SHARED "Build shared libraries" FALSE) +boolean_number(ENABLE_SHARED) +option(ENABLE_STATIC "Build static libraries" TRUE) +boolean_number(ENABLE_STATIC) +option(REQUIRE_SIMD "Generate a fatal error if SIMD extensions are not available for this platform (default is to fall back to a non-SIMD build)" FALSE) +boolean_number(REQUIRE_SIMD) +option(WITH_12BIT "Encode/decode JPEG images with 12-bit samples (implies WITH_ARITH_DEC=0 WITH_ARITH_ENC=0 WITH_JAVA=0 WITH_SIMD=0 WITH_TURBOJPEG=0 )" FALSE) +boolean_number(WITH_12BIT) +option(WITH_ARITH_DEC "Include arithmetic decoding support when emulating the libjpeg v6b API/ABI" TRUE) +boolean_number(WITH_ARITH_DEC) +option(WITH_ARITH_ENC "Include arithmetic encoding support when emulating the libjpeg v6b API/ABI" TRUE) +boolean_number(WITH_ARITH_ENC) +if(CMAKE_C_COMPILER_ABI MATCHES "ELF X32") + set(WITH_JAVA 0) +else() + option(WITH_JAVA "Build Java wrapper for the TurboJPEG API library (implies ENABLE_SHARED=1)" FALSE) + boolean_number(WITH_JAVA) +endif() +option(WITH_JPEG7 "Emulate libjpeg v7 API/ABI (this makes ${CMAKE_PROJECT_NAME} backward-incompatible with libjpeg v6b)" FALSE) +boolean_number(WITH_JPEG7) +option(WITH_JPEG8 "Emulate libjpeg v8 API/ABI (this makes ${CMAKE_PROJECT_NAME} backward-incompatible with libjpeg v6b)" FALSE) +boolean_number(WITH_JPEG8) +option(WITH_MEM_SRCDST "Include in-memory source/destination manager functions when emulating the libjpeg v6b or v7 API/ABI" TRUE) +boolean_number(WITH_MEM_SRCDST) +option(WITH_SIMD "Include SIMD extensions, if available for this platform" FALSE) +boolean_number(WITH_SIMD) +option(WITH_TURBOJPEG "Include the TurboJPEG API library and associated test programs" FALSE) +boolean_number(WITH_TURBOJPEG) +option(WITH_FUZZ "Build fuzz targets" FALSE) + +macro(report_option var desc) + if(${var}) + message(STATUS "${desc} enabled (${var} = ${${var}})") + else() + message(STATUS "${desc} disabled (${var} = ${${var}})") + endif() +endmacro() + +if(WITH_JAVA) + set(ENABLE_SHARED 1) +endif() + +# Explicitly setting CMAKE_POSITION_INDEPENDENT_CODE=FALSE disables PIC for all +# targets, which will cause the shared library builds to fail. Thus, if shared +# libraries are enabled and CMAKE_POSITION_INDEPENDENT_CODE is explicitly set +# to FALSE, we need to unset it, thus restoring the default behavior +# (automatically using PIC for shared library targets.) +if(DEFINED CMAKE_POSITION_INDEPENDENT_CODE AND + NOT CMAKE_POSITION_INDEPENDENT_CODE AND ENABLE_SHARED) + unset(CMAKE_POSITION_INDEPENDENT_CODE CACHE) +endif() + +report_option(ENABLE_SHARED "Shared libraries") +report_option(ENABLE_STATIC "Static libraries") + +if(ENABLE_SHARED) + set(CMAKE_INSTALL_RPATH ${CMAKE_INSTALL_FULL_LIBDIR}) +endif() + +if(WITH_JPEG8 OR WITH_JPEG7) + set(WITH_ARITH_ENC 1) + set(WITH_ARITH_DEC 1) +endif() +if(WITH_JPEG8) + set(WITH_MEM_SRCDST 0) +endif() + +if(WITH_12BIT) + set(WITH_ARITH_DEC 0) + set(WITH_ARITH_ENC 0) + set(WITH_JAVA 0) + set(WITH_SIMD 0) + set(WITH_TURBOJPEG 0) + set(BITS_IN_JSAMPLE 12) +else() + set(BITS_IN_JSAMPLE 8) +endif() +report_option(WITH_12BIT "12-bit JPEG support") + +if(WITH_ARITH_DEC) + set(D_ARITH_CODING_SUPPORTED 1) +endif() +if(NOT WITH_12BIT) + report_option(WITH_ARITH_DEC "Arithmetic decoding support") +endif() + +if(WITH_ARITH_ENC) + set(C_ARITH_CODING_SUPPORTED 1) +endif() +if(NOT WITH_12BIT) + report_option(WITH_ARITH_ENC "Arithmetic encoding support") +endif() + +if(NOT WITH_12BIT) + report_option(WITH_TURBOJPEG "TurboJPEG API library") + report_option(WITH_JAVA "TurboJPEG Java wrapper") +endif() + +if(WITH_MEM_SRCDST) + set(MEM_SRCDST_SUPPORTED 1) + set(MEM_SRCDST_FUNCTIONS "global: jpeg_mem_dest; jpeg_mem_src;") +endif() +if(NOT WITH_JPEG8) + report_option(WITH_MEM_SRCDST "In-memory source/destination managers") +endif() + +set(SO_AGE 2) +if(WITH_MEM_SRCDST) + set(SO_AGE 3) +endif() + +if(WITH_JPEG8) + set(JPEG_LIB_VERSION 80) +elseif(WITH_JPEG7) + set(JPEG_LIB_VERSION 70) +else() + set(JPEG_LIB_VERSION 62) +endif() + +math(EXPR JPEG_LIB_VERSION_DIV10 "${JPEG_LIB_VERSION} / 10") +math(EXPR JPEG_LIB_VERSION_MOD10 "${JPEG_LIB_VERSION} % 10") +if(JPEG_LIB_VERSION STREQUAL "62") + set(DEFAULT_SO_MAJOR_VERSION ${JPEG_LIB_VERSION}) +else() + set(DEFAULT_SO_MAJOR_VERSION ${JPEG_LIB_VERSION_DIV10}) +endif() +if(JPEG_LIB_VERSION STREQUAL "80") + set(DEFAULT_SO_MINOR_VERSION 2) +else() + set(DEFAULT_SO_MINOR_VERSION 0) +endif() + +# This causes SO_MAJOR_VERSION/SO_MINOR_VERSION to reset to defaults if +# WITH_JPEG7 or WITH_JPEG8 has changed. +if((DEFINED WITH_JPEG7_INT AND NOT WITH_JPEG7 EQUAL WITH_JPEG7_INT) OR + (DEFINED WITH_JPEG8_INT AND NOT WITH_JPEG8 EQUAL WITH_JPEG8_INT)) + set(FORCE_SO_VERSION "FORCE") +endif() +set(WITH_JPEG7_INT ${WITH_JPEG7} CACHE INTERNAL "") +set(WITH_JPEG8_INT ${WITH_JPEG8} CACHE INTERNAL "") + +set(SO_MAJOR_VERSION ${DEFAULT_SO_MAJOR_VERSION} CACHE STRING + "Major version of the libjpeg API shared library (default: ${DEFAULT_SO_MAJOR_VERSION})" + ${FORCE_SO_VERSION}) +set(SO_MINOR_VERSION ${DEFAULT_SO_MINOR_VERSION} CACHE STRING + "Minor version of the libjpeg API shared library (default: ${DEFAULT_SO_MINOR_VERSION})" + ${FORCE_SO_VERSION}) + +set(JPEG_LIB_VERSION_DECIMAL "${JPEG_LIB_VERSION_DIV10}.${JPEG_LIB_VERSION_MOD10}") +message(STATUS "Emulating libjpeg API/ABI v${JPEG_LIB_VERSION_DECIMAL} (WITH_JPEG7 = ${WITH_JPEG7}, WITH_JPEG8 = ${WITH_JPEG8})") +message(STATUS "libjpeg API shared library version = ${SO_MAJOR_VERSION}.${SO_AGE}.${SO_MINOR_VERSION}") + +# Because the TurboJPEG API library uses versioned symbols and changes the +# names of functions whenever they are modified in a backward-incompatible +# manner, it is always backward-ABI-compatible with itself, so the major and +# minor SO versions don't change. However, we increase the middle number (the +# SO "age") whenever functions are added to the API. +set(TURBOJPEG_SO_MAJOR_VERSION 0) +set(TURBOJPEG_SO_AGE 2) +set(TURBOJPEG_SO_VERSION 0.${TURBOJPEG_SO_AGE}.0) + + +############################################################################### +# COMPILER SETTINGS +############################################################################### + +if(MSVC) + option(WITH_CRT_DLL + "Link all ${CMAKE_PROJECT_NAME} libraries and executables with the C run-time DLL (msvcr*.dll) instead of the static C run-time library (libcmt*.lib.) The default is to use the C run-time DLL only with the libraries and executables that need it." + FALSE) + if(NOT WITH_CRT_DLL) + # Use the static C library for all build types + foreach(var CMAKE_C_FLAGS CMAKE_C_FLAGS_DEBUG CMAKE_C_FLAGS_RELEASE + CMAKE_C_FLAGS_MINSIZEREL CMAKE_C_FLAGS_RELWITHDEBINFO) + if(${var} MATCHES "/MD") + string(REGEX REPLACE "/MD" "/MT" ${var} "${${var}}") + endif() + endforeach() + endif() + add_definitions(-D_CRT_NONSTDC_NO_WARNINGS) +endif() + +if(CMAKE_COMPILER_IS_GNUCC OR CMAKE_C_COMPILER_ID STREQUAL "Clang") + # Use the maximum optimization level for release builds + foreach(var CMAKE_C_FLAGS_RELEASE CMAKE_C_FLAGS_RELWITHDEBINFO) + if(${var} MATCHES "-O2") + string(REGEX REPLACE "-O2" "-O3" ${var} "${${var}}") + endif() + endforeach() +endif() + +if(CMAKE_SYSTEM_NAME STREQUAL "SunOS") + if(CMAKE_C_COMPILER_ID MATCHES "SunPro") + # Use the maximum optimization level for release builds + foreach(var CMAKE_C_FLAGS_RELEASE CMAKE_C_FLAGS_RELWITHDEBINFO) + if(${var} MATCHES "-xO3") + string(REGEX REPLACE "-xO3" "-xO5" ${var} "${${var}}") + endif() + if(${var} MATCHES "-xO2") + string(REGEX REPLACE "-xO2" "-xO5" ${var} "${${var}}") + endif() + endforeach() + endif() +endif() + +string(TOUPPER ${CMAKE_BUILD_TYPE} CMAKE_BUILD_TYPE_UC) + +set(EFFECTIVE_C_FLAGS "${CMAKE_C_FLAGS} ${CMAKE_C_FLAGS_${CMAKE_BUILD_TYPE_UC}}") +message(STATUS "Compiler flags = ${EFFECTIVE_C_FLAGS}") + +set(EFFECTIVE_LD_FLAGS "${CMAKE_EXE_LINKER_FLAGS} ${CMAKE_EXE_LINKER_FLAGS_${CMAKE_BUILD_TYPE_UC}}") +message(STATUS "Linker flags = ${EFFECTIVE_LD_FLAGS}") + +include(CheckCSourceCompiles) +include(CheckIncludeFiles) +include(CheckTypeSize) + +check_type_size("size_t" SIZE_T) +check_type_size("unsigned long" UNSIGNED_LONG) + +if(SIZE_T EQUAL UNSIGNED_LONG) + check_c_source_compiles("int main(int argc, char **argv) { unsigned long a = argc; return __builtin_ctzl(a); }" + HAVE_BUILTIN_CTZL) +endif() +if(MSVC) + check_include_files("intrin.h" HAVE_INTRIN_H) +endif() + +if(UNIX) + if(CMAKE_CROSSCOMPILING) + set(RIGHT_SHIFT_IS_UNSIGNED 0) + else() + include(CheckCSourceRuns) + check_c_source_runs(" + #include + #include + int is_shifting_signed (long arg) { + long res = arg >> 4; + if (res == -0x7F7E80CL) + return 1; /* right shift is signed */ + /* see if unsigned-shift hack will fix it. */ + /* we can't just test exact value since it depends on width of long... */ + res |= (~0L) << (32-4); + if (res == -0x7F7E80CL) + return 0; /* right shift is unsigned */ + printf(\"Right shift isn't acting as I expect it to.\\\\n\"); + printf(\"I fear the JPEG software will not work at all.\\\\n\\\\n\"); + return 0; /* try it with unsigned anyway */ + } + int main (void) { + exit(is_shifting_signed(-0x7F7E80B1L)); + }" RIGHT_SHIFT_IS_UNSIGNED) + endif() +endif() + +if(MSVC) + set(INLINE_OPTIONS "__inline;inline") +else() + set(INLINE_OPTIONS "__inline__;inline") +endif() +option(FORCE_INLINE "Force function inlining" TRUE) +boolean_number(FORCE_INLINE) +if(FORCE_INLINE) + if(MSVC) + list(INSERT INLINE_OPTIONS 0 "__forceinline") + else() + list(INSERT INLINE_OPTIONS 0 "inline __attribute__((always_inline))") + list(INSERT INLINE_OPTIONS 0 "__inline__ __attribute__((always_inline))") + endif() +endif() +foreach(inline ${INLINE_OPTIONS}) + check_c_source_compiles("${inline} static int foo(void) { return 0; } int main(void) { return foo(); }" + INLINE_WORKS) + if(INLINE_WORKS) + set(INLINE ${inline}) + break() + endif() +endforeach() +if(NOT INLINE_WORKS) + message(FATAL_ERROR "Could not determine how to inline functions.") +endif() +message(STATUS "INLINE = ${INLINE} (FORCE_INLINE = ${FORCE_INLINE})") + +if(WITH_TURBOJPEG) + if(MSVC) + set(THREAD_LOCAL "__declspec(thread)") + else() + set(THREAD_LOCAL "__thread") + endif() + check_c_source_compiles("${THREAD_LOCAL} int i; int main(void) { i = 0; return i; }" HAVE_THREAD_LOCAL) + if(HAVE_THREAD_LOCAL) + message(STATUS "THREAD_LOCAL = ${THREAD_LOCAL}") + else() + message(WARNING "Thread-local storage is not available. The TurboJPEG API library's global error handler will not be thread-safe.") + unset(THREAD_LOCAL) + endif() +endif() + +if(UNIX AND NOT APPLE) + file(WRITE ${CMAKE_CURRENT_BINARY_DIR}/conftest.map "VERS_1 { global: *; };") + set(CMAKE_REQUIRED_FLAGS + "-Wl,--version-script,${CMAKE_CURRENT_BINARY_DIR}/conftest.map") + check_c_source_compiles("int main(void) { return 0; }" HAVE_VERSION_SCRIPT) + set(CMAKE_REQUIRED_FLAGS) + file(REMOVE ${CMAKE_CURRENT_BINARY_DIR}/conftest.map) + if(HAVE_VERSION_SCRIPT) + message(STATUS "Linker supports GNU-style version scripts") + set(MAPFLAG "-Wl,--version-script,") + set(TJMAPFLAG "-Wl,--version-script,") + else() + message(STATUS "Linker does not support GNU-style version scripts") + if(CMAKE_SYSTEM_NAME STREQUAL "SunOS") + # The Solaris linker doesn't like our version script for the libjpeg API + # library, but the version script for the TurboJPEG API library should + # still work. + file(WRITE ${CMAKE_CURRENT_BINARY_DIR}/conftest.map + "VERS_1 { global: foo; local: *; }; VERS_2 { global: foo2; } VERS_1;") + set(CMAKE_REQUIRED_FLAGS "-Wl,-M,${CMAKE_CURRENT_BINARY_DIR}/conftest.map -shared") + check_c_source_compiles("int foo() { return 0; } int foo2() { return 2; }" + HAVE_MAPFILE) + set(CMAKE_REQUIRED_FLAGS) + file(REMOVE ${CMAKE_CURRENT_BINARY_DIR}/conftest.map) + if(HAVE_MAPFILE) + message(STATUS "Linker supports mapfiles") + set(TJMAPFLAG "-Wl,-M,") + else() + message(STATUS "Linker does not support mapfiles") + endif() + endif() + endif() +endif() + +# Generate files +if(WIN32) + configure_file(${CMAKE_CURRENT_SOURCE_DIR}/win/jconfig.h.in jconfig.h) +else() + configure_file(jconfig.h.in jconfig.h) +endif() +configure_file(jconfigint.h.in jconfigint.h) +configure_file(jversion.h.in jversion.h) +if(UNIX) + configure_file(libjpeg.map.in libjpeg.map) +endif() + +# Include directories and compiler definitions +include_directories(${CMAKE_CURRENT_BINARY_DIR} ${CMAKE_CURRENT_SOURCE_DIR}) + + +############################################################################### +# TARGETS +############################################################################### + +if(CMAKE_EXECUTABLE_SUFFIX_TMP) + set(CMAKE_EXECUTABLE_SUFFIX ${CMAKE_EXECUTABLE_SUFFIX_TMP}) +endif() +message(STATUS "CMAKE_EXECUTABLE_SUFFIX = ${CMAKE_EXECUTABLE_SUFFIX}") + +set(JPEG_SOURCES jcapimin.c jcapistd.c jccoefct.c jccolor.c jcdctmgr.c jchuff.c + jcicc.c jcinit.c jcmainct.c jcmarker.c jcmaster.c jcomapi.c jcparam.c + jcphuff.c jcprepct.c jcsample.c jctrans.c jdapimin.c jdapistd.c jdatadst.c + jdatasrc.c jdcoefct.c jdcolor.c jddctmgr.c jdhuff.c jdicc.c jdinput.c + jdmainct.c jdmarker.c jdmaster.c jdmerge.c jdphuff.c jdpostct.c jdsample.c + jdtrans.c jerror.c jfdctflt.c jfdctfst.c jfdctint.c jidctflt.c jidctfst.c + jidctint.c jidctred.c jquant1.c jquant2.c jutils.c jmemmgr.c jmemnobs.c) + +if(WITH_ARITH_ENC OR WITH_ARITH_DEC) + set(JPEG_SOURCES ${JPEG_SOURCES} jaricom.c) +endif() + +if(WITH_ARITH_ENC) + set(JPEG_SOURCES ${JPEG_SOURCES} jcarith.c) +endif() + +if(WITH_ARITH_DEC) + set(JPEG_SOURCES ${JPEG_SOURCES} jdarith.c) +endif() + +if(WITH_SIMD) + add_subdirectory(simd) + if(NEON_INTRINSICS) + add_definitions(-DNEON_INTRINSICS) + endif() +elseif(NOT WITH_12BIT) + message(STATUS "SIMD extensions: None (WITH_SIMD = ${WITH_SIMD})") +endif() +if(WITH_SIMD) + message(STATUS "SIMD extensions: ${CPU_TYPE} (WITH_SIMD = ${WITH_SIMD})") + if(MSVC_IDE OR XCODE) + set_source_files_properties(${SIMD_OBJS} PROPERTIES GENERATED 1) + endif() +else() + add_library(simd OBJECT jsimd_none.c) + if(NOT WIN32 AND (CMAKE_POSITION_INDEPENDENT_CODE OR ENABLE_SHARED)) + set_target_properties(simd PROPERTIES POSITION_INDEPENDENT_CODE 1) + endif() +endif() + +if(WITH_JAVA) + add_subdirectory(java) +endif() + +if(ENABLE_SHARED) + add_subdirectory(sharedlib) +endif() + +if(ENABLE_STATIC) + add_library(jpeg-static STATIC ${JPEG_SOURCES} $ + ${SIMD_OBJS}) + if(NOT MSVC) + set_target_properties(jpeg-static PROPERTIES OUTPUT_NAME jpeg) + endif() +endif() + +if(WITH_TURBOJPEG) + if(ENABLE_SHARED) + set(TURBOJPEG_SOURCES ${JPEG_SOURCES} $ ${SIMD_OBJS} + turbojpeg.c transupp.c jdatadst-tj.c jdatasrc-tj.c rdbmp.c rdppm.c + wrbmp.c wrppm.c) + set(TJMAPFILE ${CMAKE_CURRENT_SOURCE_DIR}/turbojpeg-mapfile) + if(WITH_JAVA) + set(TURBOJPEG_SOURCES ${TURBOJPEG_SOURCES} turbojpeg-jni.c) + include_directories(${JAVA_INCLUDE_PATH} ${JAVA_INCLUDE_PATH2}) + set(TJMAPFILE ${CMAKE_CURRENT_SOURCE_DIR}/turbojpeg-mapfile.jni) + endif() + if(MSVC) + configure_file(${CMAKE_SOURCE_DIR}/win/turbojpeg.rc.in + ${CMAKE_BINARY_DIR}/win/turbojpeg.rc) + set(TURBOJPEG_SOURCES ${TURBOJPEG_SOURCES} + ${CMAKE_BINARY_DIR}/win/turbojpeg.rc) + endif() + add_library(turbojpeg SHARED ${TURBOJPEG_SOURCES}) + set_property(TARGET turbojpeg PROPERTY COMPILE_FLAGS + "-DBMP_SUPPORTED -DPPM_SUPPORTED") + if(WIN32) + set_target_properties(turbojpeg PROPERTIES DEFINE_SYMBOL DLLDEFINE) + endif() + if(MINGW) + set_target_properties(turbojpeg PROPERTIES LINK_FLAGS -Wl,--kill-at) + endif() + if(APPLE AND (NOT CMAKE_OSX_DEPLOYMENT_TARGET OR + CMAKE_OSX_DEPLOYMENT_TARGET VERSION_GREATER 10.4)) + if(NOT CMAKE_SHARED_LIBRARY_RUNTIME_C_FLAG) + set(CMAKE_SHARED_LIBRARY_RUNTIME_C_FLAG "-Wl,-rpath,") + endif() + set_target_properties(turbojpeg PROPERTIES MACOSX_RPATH 1) + endif() + set_target_properties(turbojpeg PROPERTIES + SOVERSION ${TURBOJPEG_SO_MAJOR_VERSION} VERSION ${TURBOJPEG_SO_VERSION}) + if(TJMAPFLAG) + set_target_properties(turbojpeg PROPERTIES + LINK_FLAGS "${TJMAPFLAG}${TJMAPFILE}") + endif() + + add_executable(tjunittest tjunittest.c tjutil.c md5/md5.c md5/md5hl.c) + target_link_libraries(tjunittest turbojpeg) + + add_executable(tjbench tjbench.c tjutil.c) + target_link_libraries(tjbench turbojpeg) + if(UNIX) + target_link_libraries(tjbench m) + endif() + + add_executable(tjexample tjexample.c) + target_link_libraries(tjexample turbojpeg) + endif() + + if(ENABLE_STATIC) + add_library(turbojpeg-static STATIC ${JPEG_SOURCES} $ + ${SIMD_OBJS} turbojpeg.c transupp.c jdatadst-tj.c jdatasrc-tj.c rdbmp.c + rdppm.c wrbmp.c wrppm.c) + set_property(TARGET turbojpeg-static PROPERTY COMPILE_FLAGS + "-DBMP_SUPPORTED -DPPM_SUPPORTED") + if(NOT MSVC) + set_target_properties(turbojpeg-static PROPERTIES OUTPUT_NAME turbojpeg) + endif() + + add_executable(tjunittest-static tjunittest.c tjutil.c md5/md5.c + md5/md5hl.c) + target_link_libraries(tjunittest-static turbojpeg-static) + + add_executable(tjbench-static tjbench.c tjutil.c) + target_link_libraries(tjbench-static turbojpeg-static) + if(UNIX) + target_link_libraries(tjbench-static m) + endif() + endif() +endif() + +if(WIN32) + set(USE_SETMODE "-DUSE_SETMODE") +endif() +if(WITH_12BIT) + set(COMPILE_FLAGS "-DGIF_SUPPORTED -DPPM_SUPPORTED ${USE_SETMODE}") +else() + set(COMPILE_FLAGS "-DBMP_SUPPORTED -DGIF_SUPPORTED -DPPM_SUPPORTED -DTARGA_SUPPORTED ${USE_SETMODE}") + set(CJPEG_BMP_SOURCES rdbmp.c rdtarga.c) + set(DJPEG_BMP_SOURCES wrbmp.c wrtarga.c) +endif() + +if(ENABLE_STATIC) + add_executable(cjpeg-static cjpeg.c cdjpeg.c rdgif.c rdppm.c rdswitch.c + ${CJPEG_BMP_SOURCES}) + set_property(TARGET cjpeg-static PROPERTY COMPILE_FLAGS ${COMPILE_FLAGS}) + target_link_libraries(cjpeg-static jpeg-static) + + add_executable(djpeg-static djpeg.c cdjpeg.c rdcolmap.c rdswitch.c wrgif.c + wrppm.c ${DJPEG_BMP_SOURCES}) + set_property(TARGET djpeg-static PROPERTY COMPILE_FLAGS ${COMPILE_FLAGS}) + target_link_libraries(djpeg-static jpeg-static) + + add_executable(jpegtran-static jpegtran.c cdjpeg.c rdswitch.c transupp.c) + target_link_libraries(jpegtran-static jpeg-static) + set_property(TARGET jpegtran-static PROPERTY COMPILE_FLAGS "${USE_SETMODE}") +endif() + +add_executable(rdjpgcom rdjpgcom.c) + +add_executable(wrjpgcom wrjpgcom.c) + + +############################################################################### +# TESTS +############################################################################### + +if(WITH_FUZZ) + add_subdirectory(fuzz) +endif() + +add_executable(strtest strtest.c) + +add_subdirectory(md5) + +if(MSVC_IDE OR XCODE) + set(OBJDIR "\${CTEST_CONFIGURATION_TYPE}/") +else() + set(OBJDIR "") +endif() + +enable_testing() + +if(WITH_12BIT) + set(TESTORIG testorig12.jpg) + set(MD5_JPEG_RGB_ISLOW 9d7369207c520d37f2c1cbfcb82b2964) + set(MD5_JPEG_RGB_ISLOW2 a00bd20d8ae49684640ef7177d2e0b64) + set(MD5_PPM_RGB_ISLOW f3301d2219783b8b3d942b7239fa50c0) + set(MD5_JPEG_422_IFAST_OPT 7322e3bd2f127f7de4b40d4480ce60e4) + set(MD5_PPM_422_IFAST 79807fa552899e66a04708f533e16950) + set(MD5_JPEG_440_ISLOW e25c1912e38367be505a89c410c1c2d2) + set(MD5_PPM_440_ISLOW e7d2e26288870cfcb30f3114ad01e380) + set(MD5_PPM_422M_IFAST 07737bfe8a7c1c87aaa393a0098d16b0) + set(MD5_JPEG_420_IFAST_Q100_PROG 9447cef4803d9b0f74bcf333cc710a29) + set(MD5_PPM_420_Q100_IFAST 1b3730122709f53d007255e8dfd3305e) + set(MD5_PPM_420M_Q100_IFAST 980a1a3c5bf9510022869d30b7d26566) + set(MD5_JPEG_GRAY_ISLOW 235c90707b16e2e069f37c888b2636d9) + set(MD5_PPM_GRAY_ISLOW 7213c10af507ad467da5578ca5ee1fca) + set(MD5_PPM_GRAY_ISLOW_RGB e96ee81c30a6ed422d466338bd3de65d) + set(MD5_JPEG_420S_IFAST_OPT 7af8e60be4d9c227ec63ac9b6630855e) + + set(MD5_JPEG_3x2_FLOAT_PROG_SSE a8c17daf77b457725ec929e215b603f8) + set(MD5_PPM_3x2_FLOAT_SSE 42876ab9e5c2f76a87d08db5fbd57956) + set(MD5_JPEG_3x2_FLOAT_PROG_NO_FP_CONTRACT a8c17daf77b457725ec929e215b603f8) + set(MD5_PPM_3x2_FLOAT_NO_FP_CONTRACT ${MD5_PPM_3x2_FLOAT_SSE}) + set(MD5_JPEG_3x2_FLOAT_PROG_FP_CONTRACT + ${MD5_JPEG_3x2_FLOAT_PROG_NO_FP_CONTRACT}) + set(MD5_PPM_3x2_FLOAT_FP_CONTRACT ${MD5_PPM_3x2_FLOAT_SSE}) + set(MD5_JPEG_3x2_FLOAT_PROG_387 bc6dbbefac2872f6b9d6c4a0ae60c3c0) + set(MD5_PPM_3x2_FLOAT_387 bcc5723c61560463ac60f772e742d092) + set(MD5_JPEG_3x2_FLOAT_PROG_MSVC e27840755870fa849872e58aa0cd1400) + set(MD5_PPM_3x2_FLOAT_MSVC 6c2880b83bb1aa41dfe330e7a9768690) + + set(MD5_JPEG_3x2_IFAST_PROG 1396cc2b7185cfe943d408c9d305339e) + set(MD5_PPM_3x2_IFAST 3975985ef6eeb0a2cdc58daa651ccc00) + set(MD5_PPM_420M_ISLOW_2_1 4ca6be2a6f326ff9eaab63e70a8259c0) + set(MD5_PPM_420M_ISLOW_15_8 12aa9f9534c1b3d7ba047322226365eb) + set(MD5_PPM_420M_ISLOW_13_8 f7e22817c7b25e1393e4ec101e9d4e96) + set(MD5_PPM_420M_ISLOW_11_8 800a16f9f4dc9b293197bfe11be10a82) + set(MD5_PPM_420M_ISLOW_9_8 06b7a92a9bc69f4dc36ec40f1937d55c) + set(MD5_PPM_420M_ISLOW_7_8 3ec444a14a4ab4eab88ffc49c48eca43) + set(MD5_PPM_420M_ISLOW_3_4 3e726b7ea872445b19437d1c1d4f0d93) + set(MD5_PPM_420M_ISLOW_5_8 a8a771abdc94301d20ffac119b2caccd) + set(MD5_PPM_420M_ISLOW_1_2 b419124dd5568b085787234866102866) + set(MD5_PPM_420M_ISLOW_3_8 343d19015531b7bbe746124127244fa8) + set(MD5_PPM_420M_ISLOW_1_4 35fd59d866e44659edfa3c18db2a3edb) + set(MD5_PPM_420M_ISLOW_1_8 ccaed48ac0aedefda5d4abe4013f4ad7) + set(MD5_PPM_420_ISLOW_SKIP15_31 86664cd9dc956536409e44e244d20a97) + set(MD5_PPM_420_ISLOW_PROG_CROP62x62_71_71 452a21656115a163029cfba5c04fa76a) + set(MD5_PPM_444_ISLOW_SKIP1_6 ef63901f71ef7a75cd78253fc0914f84) + set(MD5_PPM_444_ISLOW_PROG_CROP98x98_13_13 15b173fb5872d9575572fbcc1b05956f) + set(MD5_JPEG_CROP cdb35ff4b4519392690ea040c56ea99c) +else() + set(TESTORIG testorig.jpg) + set(MD5_JPEG_RGB_ISLOW 1d44a406f61da743b5fd31c0a9abdca3) + set(MD5_JPEG_RGB_ISLOW2 31d121e57b6c2934c890a7fc7763bcd4) + set(MD5_PPM_RGB_ISLOW 00a257f5393fef8821f2b88ac7421291) + set(MD5_BMP_RGB_ISLOW_565 f07d2e75073e4bb10f6c6f4d36e2e3be) + set(MD5_BMP_RGB_ISLOW_565D 4cfa0928ef3e6bb626d7728c924cfda4) + set(MD5_JPEG_422_IFAST_OPT 2540287b79d913f91665e660303ab2c8) + set(MD5_PPM_422_IFAST 35bd6b3f833bad23de82acea847129fa) + set(MD5_JPEG_440_ISLOW 538bc02bd4b4658fd85de6ece6cbeda6) + set(MD5_PPM_440_ISLOW 11e7eab7ef7ef3276934bb7e7b6bb377) + set(MD5_PPM_422M_IFAST 8dbc65323d62cca7c91ba02dd1cfa81d) + set(MD5_BMP_422M_IFAST_565 3294bd4d9a1f2b3d08ea6020d0db7065) + set(MD5_BMP_422M_IFAST_565D da98c9c7b6039511be4a79a878a9abc1) + set(MD5_JPEG_420_IFAST_Q100_PROG 0ba15f9dab81a703505f835f9dbbac6d) + set(MD5_PPM_420_Q100_IFAST 5a732542015c278ff43635e473a8a294) + set(MD5_PPM_420M_Q100_IFAST ff692ee9323a3b424894862557c092f1) + set(MD5_JPEG_GRAY_ISLOW 72b51f894b8f4a10b3ee3066770aa38d) + set(MD5_PPM_GRAY_ISLOW 8d3596c56eace32f205deccc229aa5ed) + set(MD5_PPM_GRAY_ISLOW_RGB 116424ac07b79e5e801f00508eab48ec) + set(MD5_BMP_GRAY_ISLOW_565 12f78118e56a2f48b966f792fedf23cc) + set(MD5_BMP_GRAY_ISLOW_565D bdbbd616441a24354c98553df5dc82db) + set(MD5_JPEG_420S_IFAST_OPT 388708217ac46273ca33086b22827ed8) + + set(MD5_JPEG_3x2_FLOAT_PROG_SSE 343e3f8caf8af5986ebaf0bdc13b5c71) + set(MD5_PPM_3x2_FLOAT_SSE 1a75f36e5904d6fc3a85a43da9ad89bb) + set(MD5_JPEG_3x2_FLOAT_PROG_NO_FP_CONTRACT 9bca803d2042bd1eb03819e2bf92b3e5) + set(MD5_PPM_3x2_FLOAT_NO_FP_CONTRACT f6bfab038438ed8f5522fbd33595dcdc) + set(MD5_JPEG_3x2_FLOAT_PROG_FP_CONTRACT + ${MD5_JPEG_3x2_FLOAT_PROG_NO_FP_CONTRACT}) + set(MD5_PPM_3x2_FLOAT_FP_CONTRACT 0e917a34193ef976b679a6b069b1be26) + set(MD5_JPEG_3x2_FLOAT_PROG_387 1657664a410e0822c924b54f6f65e6e9) + set(MD5_PPM_3x2_FLOAT_387 cb0a1f027f3d2917c902b5640214e025) + set(MD5_JPEG_3x2_FLOAT_PROG_MSVC 7999ce9cd0ee9b6c7043b7351ab7639d) + set(MD5_PPM_3x2_FLOAT_MSVC 28cdc448a6b75e97892f0e0f8d4b21f3) + + set(MD5_JPEG_3x2_IFAST_PROG 1ee5d2c1a77f2da495f993c8c7cceca5) + set(MD5_PPM_3x2_IFAST fd283664b3b49127984af0a7f118fccd) + set(MD5_JPEG_420_ISLOW_ARI e986fb0a637a8d833d96e8a6d6d84ea1) + set(MD5_JPEG_444_ISLOW_PROGARI 0a8f1c8f66e113c3cf635df0a475a617) + set(MD5_PPM_420M_IFAST_ARI 57251da28a35b46eecb7177d82d10e0e) + set(MD5_JPEG_420_ISLOW 9a68f56bc76e466aa7e52f415d0f4a5f) + set(MD5_PPM_420M_ISLOW_2_1 9f9de8c0612f8d06869b960b05abf9c9) + set(MD5_PPM_420M_ISLOW_15_8 b6875bc070720b899566cc06459b63b7) + set(MD5_PPM_420M_ISLOW_13_8 bc3452573c8152f6ae552939ee19f82f) + set(MD5_PPM_420M_ISLOW_11_8 d8cc73c0aaacd4556569b59437ba00a5) + set(MD5_PPM_420M_ISLOW_9_8 d25e61bc7eac0002f5b393aa223747b6) + set(MD5_PPM_420M_ISLOW_7_8 ddb564b7c74a09494016d6cd7502a946) + set(MD5_PPM_420M_ISLOW_3_4 8ed8e68808c3fbc4ea764fc9d2968646) + set(MD5_PPM_420M_ISLOW_5_8 a3363274999da2366a024efae6d16c9b) + set(MD5_PPM_420M_ISLOW_1_2 e692a315cea26b988c8e8b29a5dbcd81) + set(MD5_PPM_420M_ISLOW_3_8 79eca9175652ced755155c90e785a996) + set(MD5_PPM_420M_ISLOW_1_4 79cd778f8bf1a117690052cacdd54eca) + set(MD5_PPM_420M_ISLOW_1_8 391b3d4aca640c8567d6f8745eb2142f) + set(MD5_BMP_420_ISLOW_256 4980185e3776e89bd931736e1cddeee6) + set(MD5_BMP_420_ISLOW_565 bf9d13e16c4923b92e1faa604d7922cb) + set(MD5_BMP_420_ISLOW_565D 6bde71526acc44bcff76f696df8638d2) + set(MD5_BMP_420M_ISLOW_565 8dc0185245353cfa32ad97027342216f) + set(MD5_BMP_420M_ISLOW_565D ce034037d212bc403330df6f915c161b) + set(MD5_PPM_420_ISLOW_SKIP15_31 c4c65c1e43d7275cd50328a61e6534f0) + set(MD5_PPM_420_ISLOW_ARI_SKIP16_139 087c6b123db16ac00cb88c5b590bb74a) + set(MD5_PPM_420_ISLOW_PROG_CROP62x62_71_71 26eb36ccc7d1f0cb80cdabb0ac8b5d99) + set(MD5_PPM_420_ISLOW_ARI_CROP53x53_4_4 886c6775af22370257122f8b16207e6d) + set(MD5_PPM_444_ISLOW_SKIP1_6 5606f86874cf26b8fcee1117a0a436a6) + set(MD5_PPM_444_ISLOW_PROG_CROP98x98_13_13 db87dc7ce26bcdc7a6b56239ce2b9d6c) + set(MD5_PPM_444_ISLOW_ARI_CROP37x37_0_0 cb57b32bd6d03e35432362f7bf184b6d) + set(MD5_JPEG_CROP b4197f377e621c4e9b1d20471432610d) +endif() + +if(WITH_JAVA) + add_test(TJUnitTest + ${Java_JAVA_EXECUTABLE} ${JAVAARGS} -cp java/turbojpeg.jar + -Djava.library.path=${CMAKE_CURRENT_BINARY_DIR}/${OBJDIR} + TJUnitTest) + add_test(TJUnitTest-yuv + ${Java_JAVA_EXECUTABLE} ${JAVAARGS} -cp java/turbojpeg.jar + -Djava.library.path=${CMAKE_CURRENT_BINARY_DIR}/${OBJDIR} + TJUnitTest -yuv) + add_test(TJUnitTest-yuv-nopad + ${Java_JAVA_EXECUTABLE} ${JAVAARGS} -cp java/turbojpeg.jar + -Djava.library.path=${CMAKE_CURRENT_BINARY_DIR}/${OBJDIR} + TJUnitTest -yuv -noyuvpad) + add_test(TJUnitTest-bi + ${Java_JAVA_EXECUTABLE} ${JAVAARGS} -cp java/turbojpeg.jar + -Djava.library.path=${CMAKE_CURRENT_BINARY_DIR}/${OBJDIR} + TJUnitTest -bi) + add_test(TJUnitTest-bi-yuv + ${Java_JAVA_EXECUTABLE} ${JAVAARGS} -cp java/turbojpeg.jar + -Djava.library.path=${CMAKE_CURRENT_BINARY_DIR}/${OBJDIR} + TJUnitTest -bi -yuv) + add_test(TJUnitTest-bi-yuv-nopad + ${Java_JAVA_EXECUTABLE} ${JAVAARGS} -cp java/turbojpeg.jar + -Djava.library.path=${CMAKE_CURRENT_BINARY_DIR}/${OBJDIR} + TJUnitTest -bi -yuv -noyuvpad) +endif() + +set(TEST_LIBTYPES "") +if(ENABLE_SHARED) + set(TEST_LIBTYPES ${TEST_LIBTYPES} shared) +endif() +if(ENABLE_STATIC) + set(TEST_LIBTYPES ${TEST_LIBTYPES} static) +endif() + +set(TESTIMAGES ${CMAKE_CURRENT_SOURCE_DIR}/testimages) +set(MD5CMP ${CMAKE_CURRENT_BINARY_DIR}/md5/md5cmp) +if(CMAKE_CROSSCOMPILING) + file(RELATIVE_PATH TESTIMAGES ${CMAKE_CURRENT_BINARY_DIR} ${TESTIMAGES}) + file(RELATIVE_PATH MD5CMP ${CMAKE_CURRENT_BINARY_DIR} ${MD5CMP}) +endif() + +# The output of the floating point DCT/IDCT algorithms differs depending on the +# type of floating point math used, so the FLOATTEST CMake variable must be +# set in order to tell the testing system which floating point results it +# should expect: +# +# sse = validate against the expected results from the libjpeg-turbo SSE SIMD +# extensions +# no-fp-contract = validate against the expected results from the C code when +# floating point expression contraction is disabled (the +# default with Clang, with GCC when building for platforms +# that lack fused multiply-add [FMA] instructions, or when +# passing -ffp-contract=off to the compiler) +# fp-contract = validate against the expected results from the C code when +# floating point expression contraction is enabled (the default +# with GCC when building for platforms that have fused multiply- +# add [FMA] instructions or when passing -ffp-contract=fast to +# the compiler) +# 387 = validate against the expected results from the C code when the 387 FPU +# is being used for floating point math (which is generally the default +# with x86 compilers) +# msvc = validate against the expected results from the C code when compiled +# with a 32-bit version of Visual C++ + +if(CPU_TYPE STREQUAL "x86_64" OR CPU_TYPE STREQUAL "i386") + if(WITH_SIMD) + set(DEFAULT_FLOATTEST sse) + elseif(CPU_TYPE STREQUAL "x86_64") + set(DEFAULT_FLOATTEST no-fp-contract) + elseif(CPU_TYPE STREQUAL "i386" AND MSVC) + set(DEFAULT_FLOATTEST msvc) + # else we can't really set an intelligent default for i386. The appropriate + # value could be 387, no-fp-contract, or fp-contract, depending on the + # compiler and compiler options. We leave it to the user to set FLOATTEST + # manually. + endif() +else() + if((CPU_TYPE STREQUAL "powerpc" OR CPU_TYPE STREQUAL "arm64") AND + NOT CMAKE_C_COMPILER_ID STREQUAL "Clang" AND NOT MSVC) + set(DEFAULT_FLOATTEST fp-contract) + else() + set(DEFAULT_FLOATTEST no-fp-contract) + endif() +endif() + +# This causes FLOATTEST to reset to the default value if WITH_SIMD has +# changed. +if(DEFINED WITH_SIMD_INT AND NOT WITH_SIMD EQUAL WITH_SIMD_INT) + set(FORCE_FLOATTEST "FORCE") +endif() +set(WITH_SIMD_INT ${WITH_SIMD} CACHE INTERNAL "") +set(FLOATTEST ${DEFAULT_FLOATTEST} CACHE STRING + "The type of floating point math used by the floating point DCT/IDCT algorithms. This tells the testing system which numerical results it should expect from those tests. [sse = libjpeg-turbo x86/x86-64 SIMD extensions, no-fp-contract = generic FPU with floating point expression contraction disabled, fp-contract = generic FPU with floating point expression contraction enabled, 387 = 387 FPU, msvc = 32-bit Visual Studio] (default = ${DEFAULT_FLOATTEST})" + ${FORCE_FLOATTEST}) +message(STATUS "FLOATTEST = ${FLOATTEST}") + +if(FLOATTEST) + string(TOUPPER ${FLOATTEST} FLOATTEST_UC) + string(REGEX REPLACE "-" "_" FLOATTEST_UC ${FLOATTEST_UC}) + string(TOLOWER ${FLOATTEST} FLOATTEST) + if(NOT FLOATTEST STREQUAL "sse" AND + NOT FLOATTEST STREQUAL "no-fp-contract" AND + NOT FLOATTEST STREQUAL "fp-contract" AND NOT FLOATTEST STREQUAL "387" AND + NOT FLOATTEST STREQUAL "msvc") + message(FATAL_ERROR "\"${FLOATTEST}\" is not a valid value for FLOATTEST.") + endif() +endif() + +foreach(libtype ${TEST_LIBTYPES}) + if(libtype STREQUAL "static") + set(suffix -static) + endif() + if(WITH_TURBOJPEG) + add_test(tjunittest-${libtype} + ${CMAKE_CROSSCOMPILING_EMULATOR} tjunittest${suffix}) + add_test(tjunittest-${libtype}-alloc + ${CMAKE_CROSSCOMPILING_EMULATOR} tjunittest${suffix} -alloc) + add_test(tjunittest-${libtype}-yuv + ${CMAKE_CROSSCOMPILING_EMULATOR} tjunittest${suffix} -yuv) + add_test(tjunittest-${libtype}-yuv-alloc + ${CMAKE_CROSSCOMPILING_EMULATOR} tjunittest${suffix} -yuv -alloc) + add_test(tjunittest-${libtype}-yuv-nopad + ${CMAKE_CROSSCOMPILING_EMULATOR} tjunittest${suffix} -yuv -noyuvpad) + add_test(tjunittest-${libtype}-bmp + ${CMAKE_CROSSCOMPILING_EMULATOR} tjunittest${suffix} -bmp) + + set(MD5_PPM_GRAY_TILE 89d3ca21213d9d864b50b4e4e7de4ca6) + set(MD5_PPM_420_8x8_TILE 847fceab15c5b7b911cb986cf0f71de3) + set(MD5_PPM_420_16x16_TILE ca45552a93687e078f7137cc4126a7b0) + set(MD5_PPM_420_32x32_TILE d8676f1d6b68df358353bba9844f4a00) + set(MD5_PPM_420_64x64_TILE 4e4c1a3d7ea4bace4f868bcbe83b7050) + set(MD5_PPM_420_128x128_TILE f24c3429c52265832beab9df72a0ceae) + set(MD5_PPM_420M_8x8_TILE bc25320e1f4c31ce2e610e43e9fd173c) + set(MD5_PPM_420M_TILE 75ffdf14602258c5c189522af57fa605) + set(MD5_PPM_422_8x8_TILE d83dacd9fc73b0a6f10c09acad64eb1e) + set(MD5_PPM_422_16x16_TILE 35077fb610d72dd743b1eb0cbcfe10fb) + set(MD5_PPM_422_32x32_TILE e6902ed8a449ecc0f0d6f2bf945f65f7) + set(MD5_PPM_422_64x64_TILE 2b4502a8f316cedbde1da7bce3d2231e) + set(MD5_PPM_422_128x128_TILE f0b5617d578f5e13c8eee215d64d4877) + set(MD5_PPM_422M_8x8_TILE 828941d7f41cd6283abd6beffb7fd51d) + set(MD5_PPM_422M_TILE e877ae1324c4a280b95376f7f018172f) + set(MD5_PPM_444_TILE 7964e41e67cfb8d0a587c0aa4798f9c3) + + # Test compressing from/decompressing to an arbitrary subregion of a larger + # image buffer + add_test(tjbench-${libtype}-tile-cp + ${CMAKE_COMMAND} -E copy_if_different ${TESTIMAGES}/testorig.ppm + testout_tile.ppm) + add_test(tjbench-${libtype}-tile + ${CMAKE_CROSSCOMPILING_EMULATOR} tjbench${suffix} testout_tile.ppm 95 + -rgb -quiet -tile -benchtime 0.01 -warmup 0) + set_tests_properties(tjbench-${libtype}-tile + PROPERTIES DEPENDS tjbench-${libtype}-tile-cp) + + foreach(tile 8 16 32 64 128) + add_test(tjbench-${libtype}-tile-gray-${tile}x${tile}-cmp + ${CMAKE_CROSSCOMPILING_EMULATOR} ${MD5CMP} ${MD5_PPM_GRAY_TILE} + testout_tile_GRAY_Q95_${tile}x${tile}.ppm) + foreach(subsamp 420 422) + add_test(tjbench-${libtype}-tile-${subsamp}-${tile}x${tile}-cmp + ${CMAKE_CROSSCOMPILING_EMULATOR} ${MD5CMP} + ${MD5_PPM_${subsamp}_${tile}x${tile}_TILE} + testout_tile_${subsamp}_Q95_${tile}x${tile}.ppm) + endforeach() + add_test(tjbench-${libtype}-tile-444-${tile}x${tile}-cmp + ${CMAKE_CROSSCOMPILING_EMULATOR} ${MD5CMP} ${MD5_PPM_444_TILE} + testout_tile_444_Q95_${tile}x${tile}.ppm) + foreach(subsamp gray 420 422 444) + set_tests_properties(tjbench-${libtype}-tile-${subsamp}-${tile}x${tile}-cmp + PROPERTIES DEPENDS tjbench-${libtype}-tile) + endforeach() + endforeach() + + add_test(tjbench-${libtype}-tilem-cp + ${CMAKE_COMMAND} -E copy_if_different ${TESTIMAGES}/testorig.ppm + testout_tilem.ppm) + add_test(tjbench-${libtype}-tilem + ${CMAKE_CROSSCOMPILING_EMULATOR} tjbench${suffix} testout_tilem.ppm 95 + -rgb -fastupsample -quiet -tile -benchtime 0.01 -warmup 0) + set_tests_properties(tjbench-${libtype}-tilem + PROPERTIES DEPENDS tjbench-${libtype}-tilem-cp) + + add_test(tjbench-${libtype}-tile-420m-8x8-cmp + ${CMAKE_CROSSCOMPILING_EMULATOR} ${MD5CMP} ${MD5_PPM_420M_8x8_TILE} + testout_tilem_420_Q95_8x8.ppm) + add_test(tjbench-${libtype}-tile-422m-8x8-cmp + ${CMAKE_CROSSCOMPILING_EMULATOR} ${MD5CMP} ${MD5_PPM_422M_8x8_TILE} + testout_tilem_422_Q95_8x8.ppm) + foreach(tile 16 32 64 128) + foreach(subsamp 420 422) + add_test(tjbench-${libtype}-tile-${subsamp}m-${tile}x${tile}-cmp + ${CMAKE_CROSSCOMPILING_EMULATOR} ${MD5CMP} + ${MD5_PPM_${subsamp}M_TILE} + testout_tilem_${subsamp}_Q95_${tile}x${tile}.ppm) + endforeach() + endforeach() + foreach(tile 8 16 32 64 128) + foreach(subsamp 420 422) + set_tests_properties(tjbench-${libtype}-tile-${subsamp}m-${tile}x${tile}-cmp + PROPERTIES DEPENDS tjbench-${libtype}-tilem) + endforeach() + endforeach() + endif() + + # These tests are carefully crafted to provide full coverage of as many of + # the underlying algorithms as possible (including all of the + # SIMD-accelerated ones.) + + macro(add_bittest PROG NAME ARGS OUTFILE INFILE MD5SUM) + add_test(${PROG}-${libtype}-${NAME} + ${CMAKE_CROSSCOMPILING_EMULATOR} ${PROG}${suffix} ${ARGS} + -outfile ${OUTFILE} ${INFILE}) + add_test(${PROG}-${libtype}-${NAME}-cmp + ${CMAKE_CROSSCOMPILING_EMULATOR} ${MD5CMP} ${MD5SUM} ${OUTFILE}) + set_tests_properties(${PROG}-${libtype}-${NAME}-cmp PROPERTIES + DEPENDS ${PROG}-${libtype}-${NAME}) + if(${ARGC} GREATER 6) + set(DEPENDS ${ARGN}) + set_tests_properties(${PROG}-${libtype}-${NAME} PROPERTIES + DEPENDS ${DEPENDS}) + endif() + endmacro() + + # CC: null SAMP: fullsize FDCT: islow ENT: huff + add_bittest(cjpeg rgb-islow "-rgb;-dct;int;-icc;${TESTIMAGES}/test1.icc" + testout_rgb_islow.jpg ${TESTIMAGES}/testorig.ppm + ${MD5_JPEG_RGB_ISLOW}) + + # CC: null SAMP: fullsize IDCT: islow ENT: huff + add_bittest(djpeg rgb-islow "-dct;int;-ppm;-icc;testout_rgb_islow.icc" + testout_rgb_islow.ppm testout_rgb_islow.jpg + ${MD5_PPM_RGB_ISLOW} cjpeg-${libtype}-rgb-islow) + + add_test(djpeg-${libtype}-rgb-islow-icc-cmp + ${CMAKE_CROSSCOMPILING_EMULATOR} ${MD5CMP} + b06a39d730129122e85c1363ed1bbc9e testout_rgb_islow.icc) + set_tests_properties(djpeg-${libtype}-rgb-islow-icc-cmp PROPERTIES + DEPENDS djpeg-${libtype}-rgb-islow) + + add_bittest(jpegtran icc "-copy;all;-icc;${TESTIMAGES}/test2.icc" + testout_rgb_islow2.jpg testout_rgb_islow.jpg + ${MD5_JPEG_RGB_ISLOW2} cjpeg-${libtype}-rgb-islow) + + if(NOT WITH_12BIT) + # CC: RGB->RGB565 SAMP: fullsize IDCT: islow ENT: huff + add_bittest(djpeg rgb-islow-565 "-dct;int;-rgb565;-dither;none;-bmp" + testout_rgb_islow_565.bmp testout_rgb_islow.jpg + ${MD5_BMP_RGB_ISLOW_565} cjpeg-${libtype}-rgb-islow) + + # CC: RGB->RGB565 (dithered) SAMP: fullsize IDCT: islow ENT: huff + add_bittest(djpeg rgb-islow-565D "-dct;int;-rgb565;-bmp" + testout_rgb_islow_565D.bmp testout_rgb_islow.jpg + ${MD5_BMP_RGB_ISLOW_565D} cjpeg-${libtype}-rgb-islow) + endif() + + # CC: RGB->YCC SAMP: fullsize/h2v1 FDCT: ifast ENT: 2-pass huff + add_bittest(cjpeg 422-ifast-opt "-sample;2x1;-dct;fast;-opt" + testout_422_ifast_opt.jpg ${TESTIMAGES}/testorig.ppm + ${MD5_JPEG_422_IFAST_OPT}) + + # CC: YCC->RGB SAMP: fullsize/h2v1 fancy IDCT: ifast ENT: huff + add_bittest(djpeg 422-ifast "-dct;fast" + testout_422_ifast.ppm testout_422_ifast_opt.jpg + ${MD5_PPM_422_IFAST} cjpeg-${libtype}-422-ifast-opt) + + # CC: RGB->YCC SAMP: fullsize/h1v2 FDCT: islow ENT: huff + add_bittest(cjpeg 440-islow "-sample;1x2;-dct;int" + testout_440_islow.jpg ${TESTIMAGES}/testorig.ppm + ${MD5_JPEG_440_ISLOW}) + + # CC: YCC->RGB SAMP: fullsize/h1v2 fancy IDCT: islow ENT: huff + add_bittest(djpeg 440-islow "-dct;int" + testout_440_islow.ppm testout_440_islow.jpg + ${MD5_PPM_440_ISLOW} cjpeg-${libtype}-440-islow) + + # CC: YCC->RGB SAMP: h2v1 merged IDCT: ifast ENT: huff + add_bittest(djpeg 422m-ifast "-dct;fast;-nosmooth" + testout_422m_ifast.ppm testout_422_ifast_opt.jpg + ${MD5_PPM_422M_IFAST} cjpeg-${libtype}-422-ifast-opt) + + if(NOT WITH_12BIT) + # CC: YCC->RGB565 SAMP: h2v1 merged IDCT: ifast ENT: huff + add_bittest(djpeg 422m-ifast-565 + "-dct;int;-nosmooth;-rgb565;-dither;none;-bmp" + testout_422m_ifast_565.bmp testout_422_ifast_opt.jpg + ${MD5_BMP_422M_IFAST_565} cjpeg-${libtype}-422-ifast-opt) + + # CC: YCC->RGB565 (dithered) SAMP: h2v1 merged IDCT: ifast ENT: huff + add_bittest(djpeg 422m-ifast-565D "-dct;int;-nosmooth;-rgb565;-bmp" + testout_422m_ifast_565D.bmp testout_422_ifast_opt.jpg + ${MD5_BMP_422M_IFAST_565D} cjpeg-${libtype}-422-ifast-opt) + endif() + + # CC: RGB->YCC SAMP: fullsize/h2v2 FDCT: ifast ENT: prog huff + add_bittest(cjpeg 420-q100-ifast-prog + "-sample;2x2;-quality;100;-dct;fast;-scans;${TESTIMAGES}/test.scan" + testout_420_q100_ifast_prog.jpg ${TESTIMAGES}/testorig.ppm + ${MD5_JPEG_420_IFAST_Q100_PROG}) + + # CC: YCC->RGB SAMP: fullsize/h2v2 fancy IDCT: ifast ENT: prog huff + add_bittest(djpeg 420-q100-ifast-prog "-dct;fast" + testout_420_q100_ifast.ppm testout_420_q100_ifast_prog.jpg + ${MD5_PPM_420_Q100_IFAST} cjpeg-${libtype}-420-q100-ifast-prog) + + # CC: YCC->RGB SAMP: h2v2 merged IDCT: ifast ENT: prog huff + add_bittest(djpeg 420m-q100-ifast-prog "-dct;fast;-nosmooth" + testout_420m_q100_ifast.ppm testout_420_q100_ifast_prog.jpg + ${MD5_PPM_420M_Q100_IFAST} cjpeg-${libtype}-420-q100-ifast-prog) + + # CC: RGB->Gray SAMP: fullsize FDCT: islow ENT: huff + add_bittest(cjpeg gray-islow "-gray;-dct;int" + testout_gray_islow.jpg ${TESTIMAGES}/testorig.ppm + ${MD5_JPEG_GRAY_ISLOW}) + + # CC: Gray->Gray SAMP: fullsize IDCT: islow ENT: huff + add_bittest(djpeg gray-islow "-dct;int" + testout_gray_islow.ppm testout_gray_islow.jpg + ${MD5_PPM_GRAY_ISLOW} cjpeg-${libtype}-gray-islow) + + # CC: Gray->RGB SAMP: fullsize IDCT: islow ENT: huff + add_bittest(djpeg gray-islow-rgb "-dct;int;-rgb" + testout_gray_islow_rgb.ppm testout_gray_islow.jpg + ${MD5_PPM_GRAY_ISLOW_RGB} cjpeg-${libtype}-gray-islow) + + if(NOT WITH_12BIT) + # CC: Gray->RGB565 SAMP: fullsize IDCT: islow ENT: huff + add_bittest(djpeg gray-islow-565 "-dct;int;-rgb565;-dither;none;-bmp" + testout_gray_islow_565.bmp testout_gray_islow.jpg + ${MD5_BMP_GRAY_ISLOW_565} cjpeg-${libtype}-gray-islow) + + # CC: Gray->RGB565 (dithered) SAMP: fullsize IDCT: islow ENT: huff + add_bittest(djpeg gray-islow-565D "-dct;int;-rgb565;-bmp" + testout_gray_islow_565D.bmp testout_gray_islow.jpg + ${MD5_BMP_GRAY_ISLOW_565D} cjpeg-${libtype}-gray-islow) + endif() + + # CC: RGB->YCC SAMP: fullsize smooth/h2v2 smooth FDCT: islow + # ENT: 2-pass huff + add_bittest(cjpeg 420s-ifast-opt "-sample;2x2;-smooth;1;-dct;int;-opt" + testout_420s_ifast_opt.jpg ${TESTIMAGES}/testorig.ppm + ${MD5_JPEG_420S_IFAST_OPT}) + + if(FLOATTEST) + # CC: RGB->YCC SAMP: fullsize/int FDCT: float ENT: prog huff + add_bittest(cjpeg 3x2-float-prog "-sample;3x2;-dct;float;-prog" + testout_3x2_float_prog.jpg ${TESTIMAGES}/testorig.ppm + ${MD5_JPEG_3x2_FLOAT_PROG_${FLOATTEST_UC}}) + + # CC: YCC->RGB SAMP: fullsize/int IDCT: float ENT: prog huff + add_bittest(djpeg 3x2-float-prog "-dct;float" + testout_3x2_float.ppm testout_3x2_float_prog.jpg + ${MD5_PPM_3x2_FLOAT_${FLOATTEST_UC}} cjpeg-${libtype}-3x2-float-prog) + endif() + + # CC: RGB->YCC SAMP: fullsize/int FDCT: ifast ENT: prog huff + add_bittest(cjpeg 3x2-ifast-prog "-sample;3x2;-dct;fast;-prog" + testout_3x2_ifast_prog.jpg ${TESTIMAGES}/testorig.ppm + ${MD5_JPEG_3x2_IFAST_PROG}) + + # CC: YCC->RGB SAMP: fullsize/int IDCT: ifast ENT: prog huff + add_bittest(djpeg 3x2-ifast-prog "-dct;fast" + testout_3x2_ifast.ppm testout_3x2_ifast_prog.jpg + ${MD5_PPM_3x2_IFAST} cjpeg-${libtype}-3x2-ifast-prog) + + if(WITH_ARITH_ENC) + # CC: YCC->RGB SAMP: fullsize/h2v2 FDCT: islow ENT: arith + add_bittest(cjpeg 420-islow-ari "-dct;int;-arithmetic" + testout_420_islow_ari.jpg ${TESTIMAGES}/testorig.ppm + ${MD5_JPEG_420_ISLOW_ARI}) + + add_bittest(jpegtran 420-islow-ari "-arithmetic" + testout_420_islow_ari2.jpg ${TESTIMAGES}/testimgint.jpg + ${MD5_JPEG_420_ISLOW_ARI}) + + # CC: YCC->RGB SAMP: fullsize FDCT: islow ENT: prog arith + add_bittest(cjpeg 444-islow-progari + "-sample;1x1;-dct;int;-prog;-arithmetic" + testout_444_islow_progari.jpg ${TESTIMAGES}/testorig.ppm + ${MD5_JPEG_444_ISLOW_PROGARI}) + endif() + + if(WITH_ARITH_DEC) + # CC: RGB->YCC SAMP: h2v2 merged IDCT: ifast ENT: arith + add_bittest(djpeg 420m-ifast-ari "-fast;-skip;1,20;-ppm" + testout_420m_ifast_ari.ppm ${TESTIMAGES}/testimgari.jpg + ${MD5_PPM_420M_IFAST_ARI}) + + add_bittest(jpegtran 420-islow "" + testout_420_islow.jpg ${TESTIMAGES}/testimgari.jpg + ${MD5_JPEG_420_ISLOW}) + endif() + + # 2/1-- CC: YCC->RGB SAMP: h2v2 merged IDCT: 16x16 islow ENT: huff + # 15/8-- CC: YCC->RGB SAMP: h2v2 merged IDCT: 15x15 islow ENT: huff + # 13/8-- CC: YCC->RGB SAMP: h2v2 merged IDCT: 13x13 islow ENT: huff + # 11/8-- CC: YCC->RGB SAMP: h2v2 merged IDCT: 11x11 islow ENT: huff + # 9/8-- CC: YCC->RGB SAMP: h2v2 merged IDCT: 9x9 islow ENT: huff + # 7/8-- CC: YCC->RGB SAMP: h2v2 merged IDCT: 7x7 islow/14x14 islow + # ENT: huff + # 3/4-- CC: YCC->RGB SAMP: h2v2 merged IDCT: 6x6 islow/12x12 islow + # ENT: huff + # 5/8-- CC: YCC->RGB SAMP: h2v2 merged IDCT: 5x5 islow/10x10 islow + # ENT: huff + # 1/2-- CC: YCC->RGB SAMP: h2v2 merged IDCT: 4x4 islow/8x8 islow + # ENT: huff + # 3/8-- CC: YCC->RGB SAMP: h2v2 merged IDCT: 3x3 islow/6x6 islow + # ENT: huff + # 1/4-- CC: YCC->RGB SAMP: h2v2 merged IDCT: 2x2 islow/4x4 islow + # ENT: huff + # 1/8-- CC: YCC->RGB SAMP: h2v2 merged IDCT: 1x1 islow/2x2 islow + # ENT: huff + foreach(scale 2_1 15_8 13_8 11_8 9_8 7_8 3_4 5_8 1_2 3_8 1_4 1_8) + string(REGEX REPLACE "_" "/" scalearg ${scale}) + add_bittest(djpeg 420m-islow-${scale} + "-dct;int;-scale;${scalearg};-nosmooth;-ppm" + testout_420m_islow_${scale}.ppm ${TESTIMAGES}/${TESTORIG} + ${MD5_PPM_420M_ISLOW_${scale}}) + endforeach() + + if(NOT WITH_12BIT) + # CC: YCC->RGB (dithered) SAMP: h2v2 fancy IDCT: islow ENT: huff + add_bittest(djpeg 420-islow-256 "-dct;int;-colors;256;-bmp" + testout_420_islow_256.bmp ${TESTIMAGES}/${TESTORIG} + ${MD5_BMP_420_ISLOW_256}) + + # CC: YCC->RGB565 SAMP: h2v2 fancy IDCT: islow ENT: huff + add_bittest(djpeg 420-islow-565 "-dct;int;-rgb565;-dither;none;-bmp" + testout_420_islow_565.bmp ${TESTIMAGES}/${TESTORIG} + ${MD5_BMP_420_ISLOW_565}) + + # CC: YCC->RGB565 (dithered) SAMP: h2v2 fancy IDCT: islow ENT: huff + add_bittest(djpeg 420-islow-565D "-dct;int;-rgb565;-bmp" + testout_420_islow_565D.bmp ${TESTIMAGES}/${TESTORIG} + ${MD5_BMP_420_ISLOW_565D}) + + # CC: YCC->RGB565 SAMP: h2v2 merged IDCT: islow ENT: huff + add_bittest(djpeg 420m-islow-565 + "-dct;int;-nosmooth;-rgb565;-dither;none;-bmp" + testout_420m_islow_565.bmp ${TESTIMAGES}/${TESTORIG} + ${MD5_BMP_420M_ISLOW_565}) + + # CC: YCC->RGB565 (dithered) SAMP: h2v2 merged IDCT: islow ENT: huff + add_bittest(djpeg 420m-islow-565D "-dct;int;-nosmooth;-rgb565;-bmp" + testout_420m_islow_565D.bmp ${TESTIMAGES}/${TESTORIG} + ${MD5_BMP_420M_ISLOW_565D}) + endif() + + # Partial decode tests. These tests are designed to cover all of the + # possible code paths in jpeg_skip_scanlines(). + + # Context rows: Yes Intra-iMCU row: Yes iMCU row prefetch: No ENT: huff + add_bittest(djpeg 420-islow-skip15_31 "-dct;int;-skip;15,31;-ppm" + testout_420_islow_skip15,31.ppm ${TESTIMAGES}/${TESTORIG} + ${MD5_PPM_420_ISLOW_SKIP15_31}) + + # Context rows: Yes Intra-iMCU row: No iMCU row prefetch: Yes ENT: arith + if(WITH_ARITH_DEC) + add_bittest(djpeg 420-islow-ari-skip16_139 "-dct;int;-skip;16,139;-ppm" + testout_420_islow_ari_skip16,139.ppm ${TESTIMAGES}/testimgari.jpg + ${MD5_PPM_420_ISLOW_ARI_SKIP16_139}) + endif() + + # Context rows: Yes Intra-iMCU row: No iMCU row prefetch: No ENT: prog huff + add_test(cjpeg-${libtype}-420-islow-prog + ${CMAKE_CROSSCOMPILING_EMULATOR} cjpeg${suffix} -dct int -prog + -outfile testout_420_islow_prog.jpg ${TESTIMAGES}/testorig.ppm) + add_bittest(djpeg 420-islow-prog-crop62x62_71_71 + "-dct;int;-crop;62x62+71+71;-ppm" + testout_420_islow_prog_crop62x62,71,71.ppm testout_420_islow_prog.jpg + ${MD5_PPM_420_ISLOW_PROG_CROP62x62_71_71} cjpeg-${libtype}-420-islow-prog) + + # Context rows: Yes Intra-iMCU row: No iMCU row prefetch: No ENT: arith + if(WITH_ARITH_DEC) + add_bittest(djpeg 420-islow-ari-crop53x53_4_4 + "-dct;int;-crop;53x53+4+4;-ppm" + testout_420_islow_ari_crop53x53,4,4.ppm ${TESTIMAGES}/testimgari.jpg + ${MD5_PPM_420_ISLOW_ARI_CROP53x53_4_4}) + endif() + + # Context rows: No Intra-iMCU row: Yes ENT: huff + add_test(cjpeg-${libtype}-444-islow + ${CMAKE_CROSSCOMPILING_EMULATOR} cjpeg${suffix} -dct int -sample 1x1 + -outfile testout_444_islow.jpg ${TESTIMAGES}/testorig.ppm) + add_bittest(djpeg 444-islow-skip1_6 "-dct;int;-skip;1,6;-ppm" + testout_444_islow_skip1,6.ppm testout_444_islow.jpg + ${MD5_PPM_444_ISLOW_SKIP1_6} cjpeg-${libtype}-444-islow) + + # Context rows: No Intra-iMCU row: No ENT: prog huff + add_test(cjpeg-${libtype}-444-islow-prog + ${CMAKE_CROSSCOMPILING_EMULATOR} cjpeg${suffix} -dct int -prog -sample 1x1 + -outfile testout_444_islow_prog.jpg ${TESTIMAGES}/testorig.ppm) + add_bittest(djpeg 444-islow-prog-crop98x98_13_13 + "-dct;int;-crop;98x98+13+13;-ppm" + testout_444_islow_prog_crop98x98,13,13.ppm testout_444_islow_prog.jpg + ${MD5_PPM_444_ISLOW_PROG_CROP98x98_13_13} cjpeg-${libtype}-444-islow-prog) + + # Context rows: No Intra-iMCU row: No ENT: arith + if(WITH_ARITH_ENC) + add_test(cjpeg-${libtype}-444-islow-ari + ${CMAKE_CROSSCOMPILING_EMULATOR} cjpeg${suffix} -dct int -arithmetic + -sample 1x1 -outfile testout_444_islow_ari.jpg + ${TESTIMAGES}/testorig.ppm) + if(WITH_ARITH_DEC) + add_bittest(djpeg 444-islow-ari-crop37x37_0_0 + "-dct;int;-crop;37x37+0+0;-ppm" + testout_444_islow_ari_crop37x37,0,0.ppm testout_444_islow_ari.jpg + ${MD5_PPM_444_ISLOW_ARI_CROP37x37_0_0} cjpeg-${libtype}-444-islow-ari) + endif() + endif() + + add_bittest(jpegtran crop "-crop;120x90+20+50;-transpose;-perfect" + testout_crop.jpg ${TESTIMAGES}/${TESTORIG} + ${MD5_JPEG_CROP}) + +endforeach() + +add_custom_target(testclean COMMAND ${CMAKE_COMMAND} -P + ${CMAKE_CURRENT_SOURCE_DIR}/cmakescripts/testclean.cmake) + +configure_file(croptest.in croptest @ONLY) +add_custom_target(croptest + COMMAND echo croptest + COMMAND ${BASH} ${CMAKE_CURRENT_BINARY_DIR}/croptest) + +if(WITH_TURBOJPEG) + configure_file(tjbenchtest.in tjbenchtest @ONLY) + configure_file(tjexampletest.in tjexampletest @ONLY) + if(WIN32) + set(BASH bash) + endif() + if(WITH_JAVA) + configure_file(tjbenchtest.java.in tjbenchtest.java @ONLY) + configure_file(tjexampletest.java.in tjexampletest.java @ONLY) + add_custom_target(tjtest + COMMAND echo tjbenchtest + COMMAND ${BASH} ${CMAKE_CURRENT_BINARY_DIR}/tjbenchtest + COMMAND echo tjbenchtest -alloc + COMMAND ${BASH} ${CMAKE_CURRENT_BINARY_DIR}/tjbenchtest -alloc + COMMAND echo tjbenchtest -yuv + COMMAND ${BASH} ${CMAKE_CURRENT_BINARY_DIR}/tjbenchtest -yuv + COMMAND echo tjbenchtest -yuv -alloc + COMMAND ${BASH} ${CMAKE_CURRENT_BINARY_DIR}/tjbenchtest -yuv -alloc + COMMAND echo tjbenchtest -progressive + COMMAND ${BASH} ${CMAKE_CURRENT_BINARY_DIR}/tjbenchtest -progressive + COMMAND echo tjbenchtest -progressive -yuv + COMMAND ${BASH} ${CMAKE_CURRENT_BINARY_DIR}/tjbenchtest -progressive -yuv + COMMAND echo tjexampletest + COMMAND ${BASH} ${CMAKE_CURRENT_BINARY_DIR}/tjexampletest + COMMAND echo tjbenchtest.java + COMMAND ${BASH} ${CMAKE_CURRENT_BINARY_DIR}/tjbenchtest.java + COMMAND echo tjbenchtest.java -yuv + COMMAND ${BASH} ${CMAKE_CURRENT_BINARY_DIR}/tjbenchtest.java -yuv + COMMAND echo tjbenchtest.java -progressive + COMMAND ${BASH} ${CMAKE_CURRENT_BINARY_DIR}/tjbenchtest.java -progressive + COMMAND echo tjexampletest.java -progressive -yuv + COMMAND ${BASH} ${CMAKE_CURRENT_BINARY_DIR}/tjbenchtest.java + -progressive -yuv + COMMAND echo tjexampletest.java + COMMAND ${BASH} ${CMAKE_CURRENT_BINARY_DIR}/tjexampletest.java + DEPENDS ${CMAKE_CURRENT_BINARY_DIR}/tjbenchtest + ${CMAKE_CURRENT_BINARY_DIR}/tjbenchtest.java + ${CMAKE_CURRENT_BINARY_DIR}/tjexampletest) + else() + add_custom_target(tjtest + COMMAND echo tjbenchtest + COMMAND ${BASH} ${CMAKE_CURRENT_BINARY_DIR}/tjbenchtest + COMMAND echo tjbenchtest -alloc + COMMAND ${BASH} ${CMAKE_CURRENT_BINARY_DIR}/tjbenchtest -alloc + COMMAND echo tjbenchtest -yuv + COMMAND ${BASH} ${CMAKE_CURRENT_BINARY_DIR}/tjbenchtest -yuv + COMMAND echo tjbenchtest -yuv -alloc + COMMAND ${BASH} ${CMAKE_CURRENT_BINARY_DIR}/tjbenchtest -yuv -alloc + COMMAND echo tjbenchtest -progressive + COMMAND ${BASH} ${CMAKE_CURRENT_BINARY_DIR}/tjbenchtest -progressive + COMMAND echo tjbenchtest -progressive -yuv + COMMAND ${BASH} ${CMAKE_CURRENT_BINARY_DIR}/tjbenchtest -progressive -yuv + COMMAND echo tjexampletest + COMMAND ${BASH} ${CMAKE_CURRENT_BINARY_DIR}/tjexampletest + DEPENDS ${CMAKE_CURRENT_BINARY_DIR}/tjbenchtest) + endif() +endif() + + +############################################################################### +# INSTALLATION +############################################################################### + +set(EXE ${CMAKE_EXECUTABLE_SUFFIX}) + +if(WITH_TURBOJPEG) + if(ENABLE_SHARED) + install(TARGETS turbojpeg EXPORT ${CMAKE_PROJECT_NAME}Targets + INCLUDES DESTINATION ${CMAKE_INSTALL_INCLUDEDIR} + ARCHIVE DESTINATION ${CMAKE_INSTALL_LIBDIR} + LIBRARY DESTINATION ${CMAKE_INSTALL_LIBDIR} + RUNTIME DESTINATION ${CMAKE_INSTALL_BINDIR}) + install(TARGETS tjbench + RUNTIME DESTINATION ${CMAKE_INSTALL_BINDIR}) + if(NOT CMAKE_VERSION VERSION_LESS "3.1" AND MSVC AND + CMAKE_C_LINKER_SUPPORTS_PDB) + install(FILES "$" + DESTINATION ${CMAKE_INSTALL_BINDIR} OPTIONAL) + endif() + endif() + if(ENABLE_STATIC) + install(TARGETS turbojpeg-static EXPORT ${CMAKE_PROJECT_NAME}Targets + INCLUDES DESTINATION ${CMAKE_INSTALL_INCLUDEDIR} + ARCHIVE DESTINATION ${CMAKE_INSTALL_LIBDIR}) + if(NOT ENABLE_SHARED) + if(MSVC_IDE OR XCODE) + set(DIR "${CMAKE_CURRENT_BINARY_DIR}/\${CMAKE_INSTALL_CONFIG_NAME}") + else() + set(DIR ${CMAKE_CURRENT_BINARY_DIR}) + endif() + install(PROGRAMS ${DIR}/tjbench-static${EXE} + DESTINATION ${CMAKE_INSTALL_BINDIR} RENAME tjbench${EXE}) + endif() + endif() + install(FILES ${CMAKE_CURRENT_SOURCE_DIR}/turbojpeg.h + DESTINATION ${CMAKE_INSTALL_INCLUDEDIR}) +endif() + +if(ENABLE_STATIC) + install(TARGETS jpeg-static EXPORT ${CMAKE_PROJECT_NAME}Targets + INCLUDES DESTINATION ${CMAKE_INSTALL_INCLUDEDIR} + ARCHIVE DESTINATION ${CMAKE_INSTALL_LIBDIR}) + if(NOT ENABLE_SHARED) + if(MSVC_IDE OR XCODE) + set(DIR "${CMAKE_CURRENT_BINARY_DIR}/\${CMAKE_INSTALL_CONFIG_NAME}") + else() + set(DIR ${CMAKE_CURRENT_BINARY_DIR}) + endif() + install(PROGRAMS ${DIR}/cjpeg-static${EXE} + DESTINATION ${CMAKE_INSTALL_BINDIR} RENAME cjpeg${EXE}) + install(PROGRAMS ${DIR}/djpeg-static${EXE} + DESTINATION ${CMAKE_INSTALL_BINDIR} RENAME djpeg${EXE}) + install(PROGRAMS ${DIR}/jpegtran-static${EXE} + DESTINATION ${CMAKE_INSTALL_BINDIR} RENAME jpegtran${EXE}) + endif() +endif() + +install(TARGETS rdjpgcom wrjpgcom RUNTIME DESTINATION ${CMAKE_INSTALL_BINDIR}) + +install(FILES ${CMAKE_CURRENT_SOURCE_DIR}/README.ijg + ${CMAKE_CURRENT_SOURCE_DIR}/README.md ${CMAKE_CURRENT_SOURCE_DIR}/example.txt + ${CMAKE_CURRENT_SOURCE_DIR}/tjexample.c + ${CMAKE_CURRENT_SOURCE_DIR}/libjpeg.txt + ${CMAKE_CURRENT_SOURCE_DIR}/structure.txt + ${CMAKE_CURRENT_SOURCE_DIR}/usage.txt ${CMAKE_CURRENT_SOURCE_DIR}/wizard.txt + ${CMAKE_CURRENT_SOURCE_DIR}/LICENSE.md DESTINATION ${CMAKE_INSTALL_DOCDIR}) +if(WITH_JAVA) + install(FILES ${CMAKE_CURRENT_SOURCE_DIR}/java/TJExample.java + DESTINATION ${CMAKE_INSTALL_DOCDIR}) +endif() + +if(UNIX OR MINGW) + install(FILES ${CMAKE_CURRENT_SOURCE_DIR}/cjpeg.1 + ${CMAKE_CURRENT_SOURCE_DIR}/djpeg.1 ${CMAKE_CURRENT_SOURCE_DIR}/jpegtran.1 + ${CMAKE_CURRENT_SOURCE_DIR}/rdjpgcom.1 + ${CMAKE_CURRENT_SOURCE_DIR}/wrjpgcom.1 + DESTINATION ${CMAKE_INSTALL_MANDIR}/man1) +endif() +install(FILES ${CMAKE_CURRENT_BINARY_DIR}/pkgscripts/libjpeg.pc + ${CMAKE_CURRENT_BINARY_DIR}/pkgscripts/libturbojpeg.pc + DESTINATION ${CMAKE_INSTALL_LIBDIR}/pkgconfig) +install(FILES + ${CMAKE_CURRENT_BINARY_DIR}/pkgscripts/${CMAKE_PROJECT_NAME}Config.cmake + ${CMAKE_CURRENT_BINARY_DIR}/pkgscripts/${CMAKE_PROJECT_NAME}ConfigVersion.cmake + DESTINATION ${CMAKE_INSTALL_LIBDIR}/cmake/${CMAKE_PROJECT_NAME}) +install(EXPORT ${CMAKE_PROJECT_NAME}Targets + NAMESPACE ${CMAKE_PROJECT_NAME}:: + DESTINATION ${CMAKE_INSTALL_LIBDIR}/cmake/${CMAKE_PROJECT_NAME}) + +install(FILES ${CMAKE_CURRENT_BINARY_DIR}/jconfig.h + ${CMAKE_CURRENT_SOURCE_DIR}/jerror.h ${CMAKE_CURRENT_SOURCE_DIR}/jmorecfg.h + ${CMAKE_CURRENT_SOURCE_DIR}/jpeglib.h + DESTINATION ${CMAKE_INSTALL_INCLUDEDIR}) + +include(cmakescripts/BuildPackages.cmake) + +configure_file("${CMAKE_CURRENT_SOURCE_DIR}/cmakescripts/cmake_uninstall.cmake.in" + "cmake_uninstall.cmake" IMMEDIATE @ONLY) + +add_custom_target(uninstall COMMAND ${CMAKE_COMMAND} -P cmake_uninstall.cmake) diff --git a/cmake/CMakeLists.txt b/cmake/CMakeLists.txt index c5a3707865..82280e3ce9 100644 --- a/cmake/CMakeLists.txt +++ b/cmake/CMakeLists.txt @@ -418,9 +418,23 @@ endif() # tweak jpeg library names to avoid linker errors with MinGW cross-compilation set(JPEG_NAMES libjpeg libjpeg-62) find_package(JPEG QUIET) +if((NOT JPEG_FOUND) AND (CMAKE_VERSION VERSION_GREATER_EQUAL 3.16)) + set(LIBJPEG_URL https://sourceforge.net/projects/libjpeg-turbo/files/2.1.3/libjpeg-turbo-2.1.3.tar.gz) + set(LIBJPEG_MD5 85244dedeaf06f636a9e7ddea6d236d8) + mark_as_advanced(LIBJPEG_URL) + mark_as_advanced(LIBJPEG_MD5) + include(ExternalCMakeProject) + ExternalCmakeProject(libjpeg ${LIBJPEG_URL} ${LIBJPEG_MD5} libjpeg-turbo . CMakeLists.libjpeg) + add_library(JPEG::JPEG ALIAS jpeg-static) + target_include_directories(lammps PRIVATE "${CMAKE_BINARY_DIR}/_deps/libjpeg-src") + target_include_directories(lammps PRIVATE "${CMAKE_BINARY_DIR}/_deps/libjpeg-build") + set(JPEG_FOUND TRUE) +endif() option(WITH_JPEG "Enable JPEG support" ${JPEG_FOUND}) if(WITH_JPEG) - find_package(JPEG REQUIRED) + if(NOT JPEG_FOUND) + find_package(JPEG REQUIRED) + endif() target_compile_definitions(lammps PRIVATE -DLAMMPS_JPEG) if(CMAKE_VERSION VERSION_LESS 3.12) target_include_directories(lammps PRIVATE ${JPEG_INCLUDE_DIRS}) From 1959cd7037d1f09dea9b187832fbb4fc3a15f57f Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sun, 22 May 2022 17:45:42 -0400 Subject: [PATCH 191/585] download, build, and link missing png and zlib libraries with CMake --- cmake/CMakeLists.libjpeg | 869 +------------------------- cmake/CMakeLists.png | 741 ++++++++++++++++++++++ cmake/CMakeLists.txt | 33 +- cmake/CMakeLists.zlib | 195 ++++++ cmake/Modules/Packages/COMPRESS.cmake | 6 +- 5 files changed, 972 insertions(+), 872 deletions(-) create mode 100644 cmake/CMakeLists.png create mode 100644 cmake/CMakeLists.zlib diff --git a/cmake/CMakeLists.libjpeg b/cmake/CMakeLists.libjpeg index f03eba40aa..f0bd85a90d 100644 --- a/cmake/CMakeLists.libjpeg +++ b/cmake/CMakeLists.libjpeg @@ -589,18 +589,6 @@ if(WITH_TURBOJPEG) set_target_properties(turbojpeg PROPERTIES LINK_FLAGS "${TJMAPFLAG}${TJMAPFILE}") endif() - - add_executable(tjunittest tjunittest.c tjutil.c md5/md5.c md5/md5hl.c) - target_link_libraries(tjunittest turbojpeg) - - add_executable(tjbench tjbench.c tjutil.c) - target_link_libraries(tjbench turbojpeg) - if(UNIX) - target_link_libraries(tjbench m) - endif() - - add_executable(tjexample tjexample.c) - target_link_libraries(tjexample turbojpeg) endif() if(ENABLE_STATIC) @@ -612,16 +600,6 @@ if(WITH_TURBOJPEG) if(NOT MSVC) set_target_properties(turbojpeg-static PROPERTIES OUTPUT_NAME turbojpeg) endif() - - add_executable(tjunittest-static tjunittest.c tjutil.c md5/md5.c - md5/md5hl.c) - target_link_libraries(tjunittest-static turbojpeg-static) - - add_executable(tjbench-static tjbench.c tjutil.c) - target_link_libraries(tjbench-static turbojpeg-static) - if(UNIX) - target_link_libraries(tjbench-static m) - endif() endif() endif() @@ -634,849 +612,4 @@ else() set(COMPILE_FLAGS "-DBMP_SUPPORTED -DGIF_SUPPORTED -DPPM_SUPPORTED -DTARGA_SUPPORTED ${USE_SETMODE}") set(CJPEG_BMP_SOURCES rdbmp.c rdtarga.c) set(DJPEG_BMP_SOURCES wrbmp.c wrtarga.c) -endif() - -if(ENABLE_STATIC) - add_executable(cjpeg-static cjpeg.c cdjpeg.c rdgif.c rdppm.c rdswitch.c - ${CJPEG_BMP_SOURCES}) - set_property(TARGET cjpeg-static PROPERTY COMPILE_FLAGS ${COMPILE_FLAGS}) - target_link_libraries(cjpeg-static jpeg-static) - - add_executable(djpeg-static djpeg.c cdjpeg.c rdcolmap.c rdswitch.c wrgif.c - wrppm.c ${DJPEG_BMP_SOURCES}) - set_property(TARGET djpeg-static PROPERTY COMPILE_FLAGS ${COMPILE_FLAGS}) - target_link_libraries(djpeg-static jpeg-static) - - add_executable(jpegtran-static jpegtran.c cdjpeg.c rdswitch.c transupp.c) - target_link_libraries(jpegtran-static jpeg-static) - set_property(TARGET jpegtran-static PROPERTY COMPILE_FLAGS "${USE_SETMODE}") -endif() - -add_executable(rdjpgcom rdjpgcom.c) - -add_executable(wrjpgcom wrjpgcom.c) - - -############################################################################### -# TESTS -############################################################################### - -if(WITH_FUZZ) - add_subdirectory(fuzz) -endif() - -add_executable(strtest strtest.c) - -add_subdirectory(md5) - -if(MSVC_IDE OR XCODE) - set(OBJDIR "\${CTEST_CONFIGURATION_TYPE}/") -else() - set(OBJDIR "") -endif() - -enable_testing() - -if(WITH_12BIT) - set(TESTORIG testorig12.jpg) - set(MD5_JPEG_RGB_ISLOW 9d7369207c520d37f2c1cbfcb82b2964) - set(MD5_JPEG_RGB_ISLOW2 a00bd20d8ae49684640ef7177d2e0b64) - set(MD5_PPM_RGB_ISLOW f3301d2219783b8b3d942b7239fa50c0) - set(MD5_JPEG_422_IFAST_OPT 7322e3bd2f127f7de4b40d4480ce60e4) - set(MD5_PPM_422_IFAST 79807fa552899e66a04708f533e16950) - set(MD5_JPEG_440_ISLOW e25c1912e38367be505a89c410c1c2d2) - set(MD5_PPM_440_ISLOW e7d2e26288870cfcb30f3114ad01e380) - set(MD5_PPM_422M_IFAST 07737bfe8a7c1c87aaa393a0098d16b0) - set(MD5_JPEG_420_IFAST_Q100_PROG 9447cef4803d9b0f74bcf333cc710a29) - set(MD5_PPM_420_Q100_IFAST 1b3730122709f53d007255e8dfd3305e) - set(MD5_PPM_420M_Q100_IFAST 980a1a3c5bf9510022869d30b7d26566) - set(MD5_JPEG_GRAY_ISLOW 235c90707b16e2e069f37c888b2636d9) - set(MD5_PPM_GRAY_ISLOW 7213c10af507ad467da5578ca5ee1fca) - set(MD5_PPM_GRAY_ISLOW_RGB e96ee81c30a6ed422d466338bd3de65d) - set(MD5_JPEG_420S_IFAST_OPT 7af8e60be4d9c227ec63ac9b6630855e) - - set(MD5_JPEG_3x2_FLOAT_PROG_SSE a8c17daf77b457725ec929e215b603f8) - set(MD5_PPM_3x2_FLOAT_SSE 42876ab9e5c2f76a87d08db5fbd57956) - set(MD5_JPEG_3x2_FLOAT_PROG_NO_FP_CONTRACT a8c17daf77b457725ec929e215b603f8) - set(MD5_PPM_3x2_FLOAT_NO_FP_CONTRACT ${MD5_PPM_3x2_FLOAT_SSE}) - set(MD5_JPEG_3x2_FLOAT_PROG_FP_CONTRACT - ${MD5_JPEG_3x2_FLOAT_PROG_NO_FP_CONTRACT}) - set(MD5_PPM_3x2_FLOAT_FP_CONTRACT ${MD5_PPM_3x2_FLOAT_SSE}) - set(MD5_JPEG_3x2_FLOAT_PROG_387 bc6dbbefac2872f6b9d6c4a0ae60c3c0) - set(MD5_PPM_3x2_FLOAT_387 bcc5723c61560463ac60f772e742d092) - set(MD5_JPEG_3x2_FLOAT_PROG_MSVC e27840755870fa849872e58aa0cd1400) - set(MD5_PPM_3x2_FLOAT_MSVC 6c2880b83bb1aa41dfe330e7a9768690) - - set(MD5_JPEG_3x2_IFAST_PROG 1396cc2b7185cfe943d408c9d305339e) - set(MD5_PPM_3x2_IFAST 3975985ef6eeb0a2cdc58daa651ccc00) - set(MD5_PPM_420M_ISLOW_2_1 4ca6be2a6f326ff9eaab63e70a8259c0) - set(MD5_PPM_420M_ISLOW_15_8 12aa9f9534c1b3d7ba047322226365eb) - set(MD5_PPM_420M_ISLOW_13_8 f7e22817c7b25e1393e4ec101e9d4e96) - set(MD5_PPM_420M_ISLOW_11_8 800a16f9f4dc9b293197bfe11be10a82) - set(MD5_PPM_420M_ISLOW_9_8 06b7a92a9bc69f4dc36ec40f1937d55c) - set(MD5_PPM_420M_ISLOW_7_8 3ec444a14a4ab4eab88ffc49c48eca43) - set(MD5_PPM_420M_ISLOW_3_4 3e726b7ea872445b19437d1c1d4f0d93) - set(MD5_PPM_420M_ISLOW_5_8 a8a771abdc94301d20ffac119b2caccd) - set(MD5_PPM_420M_ISLOW_1_2 b419124dd5568b085787234866102866) - set(MD5_PPM_420M_ISLOW_3_8 343d19015531b7bbe746124127244fa8) - set(MD5_PPM_420M_ISLOW_1_4 35fd59d866e44659edfa3c18db2a3edb) - set(MD5_PPM_420M_ISLOW_1_8 ccaed48ac0aedefda5d4abe4013f4ad7) - set(MD5_PPM_420_ISLOW_SKIP15_31 86664cd9dc956536409e44e244d20a97) - set(MD5_PPM_420_ISLOW_PROG_CROP62x62_71_71 452a21656115a163029cfba5c04fa76a) - set(MD5_PPM_444_ISLOW_SKIP1_6 ef63901f71ef7a75cd78253fc0914f84) - set(MD5_PPM_444_ISLOW_PROG_CROP98x98_13_13 15b173fb5872d9575572fbcc1b05956f) - set(MD5_JPEG_CROP cdb35ff4b4519392690ea040c56ea99c) -else() - set(TESTORIG testorig.jpg) - set(MD5_JPEG_RGB_ISLOW 1d44a406f61da743b5fd31c0a9abdca3) - set(MD5_JPEG_RGB_ISLOW2 31d121e57b6c2934c890a7fc7763bcd4) - set(MD5_PPM_RGB_ISLOW 00a257f5393fef8821f2b88ac7421291) - set(MD5_BMP_RGB_ISLOW_565 f07d2e75073e4bb10f6c6f4d36e2e3be) - set(MD5_BMP_RGB_ISLOW_565D 4cfa0928ef3e6bb626d7728c924cfda4) - set(MD5_JPEG_422_IFAST_OPT 2540287b79d913f91665e660303ab2c8) - set(MD5_PPM_422_IFAST 35bd6b3f833bad23de82acea847129fa) - set(MD5_JPEG_440_ISLOW 538bc02bd4b4658fd85de6ece6cbeda6) - set(MD5_PPM_440_ISLOW 11e7eab7ef7ef3276934bb7e7b6bb377) - set(MD5_PPM_422M_IFAST 8dbc65323d62cca7c91ba02dd1cfa81d) - set(MD5_BMP_422M_IFAST_565 3294bd4d9a1f2b3d08ea6020d0db7065) - set(MD5_BMP_422M_IFAST_565D da98c9c7b6039511be4a79a878a9abc1) - set(MD5_JPEG_420_IFAST_Q100_PROG 0ba15f9dab81a703505f835f9dbbac6d) - set(MD5_PPM_420_Q100_IFAST 5a732542015c278ff43635e473a8a294) - set(MD5_PPM_420M_Q100_IFAST ff692ee9323a3b424894862557c092f1) - set(MD5_JPEG_GRAY_ISLOW 72b51f894b8f4a10b3ee3066770aa38d) - set(MD5_PPM_GRAY_ISLOW 8d3596c56eace32f205deccc229aa5ed) - set(MD5_PPM_GRAY_ISLOW_RGB 116424ac07b79e5e801f00508eab48ec) - set(MD5_BMP_GRAY_ISLOW_565 12f78118e56a2f48b966f792fedf23cc) - set(MD5_BMP_GRAY_ISLOW_565D bdbbd616441a24354c98553df5dc82db) - set(MD5_JPEG_420S_IFAST_OPT 388708217ac46273ca33086b22827ed8) - - set(MD5_JPEG_3x2_FLOAT_PROG_SSE 343e3f8caf8af5986ebaf0bdc13b5c71) - set(MD5_PPM_3x2_FLOAT_SSE 1a75f36e5904d6fc3a85a43da9ad89bb) - set(MD5_JPEG_3x2_FLOAT_PROG_NO_FP_CONTRACT 9bca803d2042bd1eb03819e2bf92b3e5) - set(MD5_PPM_3x2_FLOAT_NO_FP_CONTRACT f6bfab038438ed8f5522fbd33595dcdc) - set(MD5_JPEG_3x2_FLOAT_PROG_FP_CONTRACT - ${MD5_JPEG_3x2_FLOAT_PROG_NO_FP_CONTRACT}) - set(MD5_PPM_3x2_FLOAT_FP_CONTRACT 0e917a34193ef976b679a6b069b1be26) - set(MD5_JPEG_3x2_FLOAT_PROG_387 1657664a410e0822c924b54f6f65e6e9) - set(MD5_PPM_3x2_FLOAT_387 cb0a1f027f3d2917c902b5640214e025) - set(MD5_JPEG_3x2_FLOAT_PROG_MSVC 7999ce9cd0ee9b6c7043b7351ab7639d) - set(MD5_PPM_3x2_FLOAT_MSVC 28cdc448a6b75e97892f0e0f8d4b21f3) - - set(MD5_JPEG_3x2_IFAST_PROG 1ee5d2c1a77f2da495f993c8c7cceca5) - set(MD5_PPM_3x2_IFAST fd283664b3b49127984af0a7f118fccd) - set(MD5_JPEG_420_ISLOW_ARI e986fb0a637a8d833d96e8a6d6d84ea1) - set(MD5_JPEG_444_ISLOW_PROGARI 0a8f1c8f66e113c3cf635df0a475a617) - set(MD5_PPM_420M_IFAST_ARI 57251da28a35b46eecb7177d82d10e0e) - set(MD5_JPEG_420_ISLOW 9a68f56bc76e466aa7e52f415d0f4a5f) - set(MD5_PPM_420M_ISLOW_2_1 9f9de8c0612f8d06869b960b05abf9c9) - set(MD5_PPM_420M_ISLOW_15_8 b6875bc070720b899566cc06459b63b7) - set(MD5_PPM_420M_ISLOW_13_8 bc3452573c8152f6ae552939ee19f82f) - set(MD5_PPM_420M_ISLOW_11_8 d8cc73c0aaacd4556569b59437ba00a5) - set(MD5_PPM_420M_ISLOW_9_8 d25e61bc7eac0002f5b393aa223747b6) - set(MD5_PPM_420M_ISLOW_7_8 ddb564b7c74a09494016d6cd7502a946) - set(MD5_PPM_420M_ISLOW_3_4 8ed8e68808c3fbc4ea764fc9d2968646) - set(MD5_PPM_420M_ISLOW_5_8 a3363274999da2366a024efae6d16c9b) - set(MD5_PPM_420M_ISLOW_1_2 e692a315cea26b988c8e8b29a5dbcd81) - set(MD5_PPM_420M_ISLOW_3_8 79eca9175652ced755155c90e785a996) - set(MD5_PPM_420M_ISLOW_1_4 79cd778f8bf1a117690052cacdd54eca) - set(MD5_PPM_420M_ISLOW_1_8 391b3d4aca640c8567d6f8745eb2142f) - set(MD5_BMP_420_ISLOW_256 4980185e3776e89bd931736e1cddeee6) - set(MD5_BMP_420_ISLOW_565 bf9d13e16c4923b92e1faa604d7922cb) - set(MD5_BMP_420_ISLOW_565D 6bde71526acc44bcff76f696df8638d2) - set(MD5_BMP_420M_ISLOW_565 8dc0185245353cfa32ad97027342216f) - set(MD5_BMP_420M_ISLOW_565D ce034037d212bc403330df6f915c161b) - set(MD5_PPM_420_ISLOW_SKIP15_31 c4c65c1e43d7275cd50328a61e6534f0) - set(MD5_PPM_420_ISLOW_ARI_SKIP16_139 087c6b123db16ac00cb88c5b590bb74a) - set(MD5_PPM_420_ISLOW_PROG_CROP62x62_71_71 26eb36ccc7d1f0cb80cdabb0ac8b5d99) - set(MD5_PPM_420_ISLOW_ARI_CROP53x53_4_4 886c6775af22370257122f8b16207e6d) - set(MD5_PPM_444_ISLOW_SKIP1_6 5606f86874cf26b8fcee1117a0a436a6) - set(MD5_PPM_444_ISLOW_PROG_CROP98x98_13_13 db87dc7ce26bcdc7a6b56239ce2b9d6c) - set(MD5_PPM_444_ISLOW_ARI_CROP37x37_0_0 cb57b32bd6d03e35432362f7bf184b6d) - set(MD5_JPEG_CROP b4197f377e621c4e9b1d20471432610d) -endif() - -if(WITH_JAVA) - add_test(TJUnitTest - ${Java_JAVA_EXECUTABLE} ${JAVAARGS} -cp java/turbojpeg.jar - -Djava.library.path=${CMAKE_CURRENT_BINARY_DIR}/${OBJDIR} - TJUnitTest) - add_test(TJUnitTest-yuv - ${Java_JAVA_EXECUTABLE} ${JAVAARGS} -cp java/turbojpeg.jar - -Djava.library.path=${CMAKE_CURRENT_BINARY_DIR}/${OBJDIR} - TJUnitTest -yuv) - add_test(TJUnitTest-yuv-nopad - ${Java_JAVA_EXECUTABLE} ${JAVAARGS} -cp java/turbojpeg.jar - -Djava.library.path=${CMAKE_CURRENT_BINARY_DIR}/${OBJDIR} - TJUnitTest -yuv -noyuvpad) - add_test(TJUnitTest-bi - ${Java_JAVA_EXECUTABLE} ${JAVAARGS} -cp java/turbojpeg.jar - -Djava.library.path=${CMAKE_CURRENT_BINARY_DIR}/${OBJDIR} - TJUnitTest -bi) - add_test(TJUnitTest-bi-yuv - ${Java_JAVA_EXECUTABLE} ${JAVAARGS} -cp java/turbojpeg.jar - -Djava.library.path=${CMAKE_CURRENT_BINARY_DIR}/${OBJDIR} - TJUnitTest -bi -yuv) - add_test(TJUnitTest-bi-yuv-nopad - ${Java_JAVA_EXECUTABLE} ${JAVAARGS} -cp java/turbojpeg.jar - -Djava.library.path=${CMAKE_CURRENT_BINARY_DIR}/${OBJDIR} - TJUnitTest -bi -yuv -noyuvpad) -endif() - -set(TEST_LIBTYPES "") -if(ENABLE_SHARED) - set(TEST_LIBTYPES ${TEST_LIBTYPES} shared) -endif() -if(ENABLE_STATIC) - set(TEST_LIBTYPES ${TEST_LIBTYPES} static) -endif() - -set(TESTIMAGES ${CMAKE_CURRENT_SOURCE_DIR}/testimages) -set(MD5CMP ${CMAKE_CURRENT_BINARY_DIR}/md5/md5cmp) -if(CMAKE_CROSSCOMPILING) - file(RELATIVE_PATH TESTIMAGES ${CMAKE_CURRENT_BINARY_DIR} ${TESTIMAGES}) - file(RELATIVE_PATH MD5CMP ${CMAKE_CURRENT_BINARY_DIR} ${MD5CMP}) -endif() - -# The output of the floating point DCT/IDCT algorithms differs depending on the -# type of floating point math used, so the FLOATTEST CMake variable must be -# set in order to tell the testing system which floating point results it -# should expect: -# -# sse = validate against the expected results from the libjpeg-turbo SSE SIMD -# extensions -# no-fp-contract = validate against the expected results from the C code when -# floating point expression contraction is disabled (the -# default with Clang, with GCC when building for platforms -# that lack fused multiply-add [FMA] instructions, or when -# passing -ffp-contract=off to the compiler) -# fp-contract = validate against the expected results from the C code when -# floating point expression contraction is enabled (the default -# with GCC when building for platforms that have fused multiply- -# add [FMA] instructions or when passing -ffp-contract=fast to -# the compiler) -# 387 = validate against the expected results from the C code when the 387 FPU -# is being used for floating point math (which is generally the default -# with x86 compilers) -# msvc = validate against the expected results from the C code when compiled -# with a 32-bit version of Visual C++ - -if(CPU_TYPE STREQUAL "x86_64" OR CPU_TYPE STREQUAL "i386") - if(WITH_SIMD) - set(DEFAULT_FLOATTEST sse) - elseif(CPU_TYPE STREQUAL "x86_64") - set(DEFAULT_FLOATTEST no-fp-contract) - elseif(CPU_TYPE STREQUAL "i386" AND MSVC) - set(DEFAULT_FLOATTEST msvc) - # else we can't really set an intelligent default for i386. The appropriate - # value could be 387, no-fp-contract, or fp-contract, depending on the - # compiler and compiler options. We leave it to the user to set FLOATTEST - # manually. - endif() -else() - if((CPU_TYPE STREQUAL "powerpc" OR CPU_TYPE STREQUAL "arm64") AND - NOT CMAKE_C_COMPILER_ID STREQUAL "Clang" AND NOT MSVC) - set(DEFAULT_FLOATTEST fp-contract) - else() - set(DEFAULT_FLOATTEST no-fp-contract) - endif() -endif() - -# This causes FLOATTEST to reset to the default value if WITH_SIMD has -# changed. -if(DEFINED WITH_SIMD_INT AND NOT WITH_SIMD EQUAL WITH_SIMD_INT) - set(FORCE_FLOATTEST "FORCE") -endif() -set(WITH_SIMD_INT ${WITH_SIMD} CACHE INTERNAL "") -set(FLOATTEST ${DEFAULT_FLOATTEST} CACHE STRING - "The type of floating point math used by the floating point DCT/IDCT algorithms. This tells the testing system which numerical results it should expect from those tests. [sse = libjpeg-turbo x86/x86-64 SIMD extensions, no-fp-contract = generic FPU with floating point expression contraction disabled, fp-contract = generic FPU with floating point expression contraction enabled, 387 = 387 FPU, msvc = 32-bit Visual Studio] (default = ${DEFAULT_FLOATTEST})" - ${FORCE_FLOATTEST}) -message(STATUS "FLOATTEST = ${FLOATTEST}") - -if(FLOATTEST) - string(TOUPPER ${FLOATTEST} FLOATTEST_UC) - string(REGEX REPLACE "-" "_" FLOATTEST_UC ${FLOATTEST_UC}) - string(TOLOWER ${FLOATTEST} FLOATTEST) - if(NOT FLOATTEST STREQUAL "sse" AND - NOT FLOATTEST STREQUAL "no-fp-contract" AND - NOT FLOATTEST STREQUAL "fp-contract" AND NOT FLOATTEST STREQUAL "387" AND - NOT FLOATTEST STREQUAL "msvc") - message(FATAL_ERROR "\"${FLOATTEST}\" is not a valid value for FLOATTEST.") - endif() -endif() - -foreach(libtype ${TEST_LIBTYPES}) - if(libtype STREQUAL "static") - set(suffix -static) - endif() - if(WITH_TURBOJPEG) - add_test(tjunittest-${libtype} - ${CMAKE_CROSSCOMPILING_EMULATOR} tjunittest${suffix}) - add_test(tjunittest-${libtype}-alloc - ${CMAKE_CROSSCOMPILING_EMULATOR} tjunittest${suffix} -alloc) - add_test(tjunittest-${libtype}-yuv - ${CMAKE_CROSSCOMPILING_EMULATOR} tjunittest${suffix} -yuv) - add_test(tjunittest-${libtype}-yuv-alloc - ${CMAKE_CROSSCOMPILING_EMULATOR} tjunittest${suffix} -yuv -alloc) - add_test(tjunittest-${libtype}-yuv-nopad - ${CMAKE_CROSSCOMPILING_EMULATOR} tjunittest${suffix} -yuv -noyuvpad) - add_test(tjunittest-${libtype}-bmp - ${CMAKE_CROSSCOMPILING_EMULATOR} tjunittest${suffix} -bmp) - - set(MD5_PPM_GRAY_TILE 89d3ca21213d9d864b50b4e4e7de4ca6) - set(MD5_PPM_420_8x8_TILE 847fceab15c5b7b911cb986cf0f71de3) - set(MD5_PPM_420_16x16_TILE ca45552a93687e078f7137cc4126a7b0) - set(MD5_PPM_420_32x32_TILE d8676f1d6b68df358353bba9844f4a00) - set(MD5_PPM_420_64x64_TILE 4e4c1a3d7ea4bace4f868bcbe83b7050) - set(MD5_PPM_420_128x128_TILE f24c3429c52265832beab9df72a0ceae) - set(MD5_PPM_420M_8x8_TILE bc25320e1f4c31ce2e610e43e9fd173c) - set(MD5_PPM_420M_TILE 75ffdf14602258c5c189522af57fa605) - set(MD5_PPM_422_8x8_TILE d83dacd9fc73b0a6f10c09acad64eb1e) - set(MD5_PPM_422_16x16_TILE 35077fb610d72dd743b1eb0cbcfe10fb) - set(MD5_PPM_422_32x32_TILE e6902ed8a449ecc0f0d6f2bf945f65f7) - set(MD5_PPM_422_64x64_TILE 2b4502a8f316cedbde1da7bce3d2231e) - set(MD5_PPM_422_128x128_TILE f0b5617d578f5e13c8eee215d64d4877) - set(MD5_PPM_422M_8x8_TILE 828941d7f41cd6283abd6beffb7fd51d) - set(MD5_PPM_422M_TILE e877ae1324c4a280b95376f7f018172f) - set(MD5_PPM_444_TILE 7964e41e67cfb8d0a587c0aa4798f9c3) - - # Test compressing from/decompressing to an arbitrary subregion of a larger - # image buffer - add_test(tjbench-${libtype}-tile-cp - ${CMAKE_COMMAND} -E copy_if_different ${TESTIMAGES}/testorig.ppm - testout_tile.ppm) - add_test(tjbench-${libtype}-tile - ${CMAKE_CROSSCOMPILING_EMULATOR} tjbench${suffix} testout_tile.ppm 95 - -rgb -quiet -tile -benchtime 0.01 -warmup 0) - set_tests_properties(tjbench-${libtype}-tile - PROPERTIES DEPENDS tjbench-${libtype}-tile-cp) - - foreach(tile 8 16 32 64 128) - add_test(tjbench-${libtype}-tile-gray-${tile}x${tile}-cmp - ${CMAKE_CROSSCOMPILING_EMULATOR} ${MD5CMP} ${MD5_PPM_GRAY_TILE} - testout_tile_GRAY_Q95_${tile}x${tile}.ppm) - foreach(subsamp 420 422) - add_test(tjbench-${libtype}-tile-${subsamp}-${tile}x${tile}-cmp - ${CMAKE_CROSSCOMPILING_EMULATOR} ${MD5CMP} - ${MD5_PPM_${subsamp}_${tile}x${tile}_TILE} - testout_tile_${subsamp}_Q95_${tile}x${tile}.ppm) - endforeach() - add_test(tjbench-${libtype}-tile-444-${tile}x${tile}-cmp - ${CMAKE_CROSSCOMPILING_EMULATOR} ${MD5CMP} ${MD5_PPM_444_TILE} - testout_tile_444_Q95_${tile}x${tile}.ppm) - foreach(subsamp gray 420 422 444) - set_tests_properties(tjbench-${libtype}-tile-${subsamp}-${tile}x${tile}-cmp - PROPERTIES DEPENDS tjbench-${libtype}-tile) - endforeach() - endforeach() - - add_test(tjbench-${libtype}-tilem-cp - ${CMAKE_COMMAND} -E copy_if_different ${TESTIMAGES}/testorig.ppm - testout_tilem.ppm) - add_test(tjbench-${libtype}-tilem - ${CMAKE_CROSSCOMPILING_EMULATOR} tjbench${suffix} testout_tilem.ppm 95 - -rgb -fastupsample -quiet -tile -benchtime 0.01 -warmup 0) - set_tests_properties(tjbench-${libtype}-tilem - PROPERTIES DEPENDS tjbench-${libtype}-tilem-cp) - - add_test(tjbench-${libtype}-tile-420m-8x8-cmp - ${CMAKE_CROSSCOMPILING_EMULATOR} ${MD5CMP} ${MD5_PPM_420M_8x8_TILE} - testout_tilem_420_Q95_8x8.ppm) - add_test(tjbench-${libtype}-tile-422m-8x8-cmp - ${CMAKE_CROSSCOMPILING_EMULATOR} ${MD5CMP} ${MD5_PPM_422M_8x8_TILE} - testout_tilem_422_Q95_8x8.ppm) - foreach(tile 16 32 64 128) - foreach(subsamp 420 422) - add_test(tjbench-${libtype}-tile-${subsamp}m-${tile}x${tile}-cmp - ${CMAKE_CROSSCOMPILING_EMULATOR} ${MD5CMP} - ${MD5_PPM_${subsamp}M_TILE} - testout_tilem_${subsamp}_Q95_${tile}x${tile}.ppm) - endforeach() - endforeach() - foreach(tile 8 16 32 64 128) - foreach(subsamp 420 422) - set_tests_properties(tjbench-${libtype}-tile-${subsamp}m-${tile}x${tile}-cmp - PROPERTIES DEPENDS tjbench-${libtype}-tilem) - endforeach() - endforeach() - endif() - - # These tests are carefully crafted to provide full coverage of as many of - # the underlying algorithms as possible (including all of the - # SIMD-accelerated ones.) - - macro(add_bittest PROG NAME ARGS OUTFILE INFILE MD5SUM) - add_test(${PROG}-${libtype}-${NAME} - ${CMAKE_CROSSCOMPILING_EMULATOR} ${PROG}${suffix} ${ARGS} - -outfile ${OUTFILE} ${INFILE}) - add_test(${PROG}-${libtype}-${NAME}-cmp - ${CMAKE_CROSSCOMPILING_EMULATOR} ${MD5CMP} ${MD5SUM} ${OUTFILE}) - set_tests_properties(${PROG}-${libtype}-${NAME}-cmp PROPERTIES - DEPENDS ${PROG}-${libtype}-${NAME}) - if(${ARGC} GREATER 6) - set(DEPENDS ${ARGN}) - set_tests_properties(${PROG}-${libtype}-${NAME} PROPERTIES - DEPENDS ${DEPENDS}) - endif() - endmacro() - - # CC: null SAMP: fullsize FDCT: islow ENT: huff - add_bittest(cjpeg rgb-islow "-rgb;-dct;int;-icc;${TESTIMAGES}/test1.icc" - testout_rgb_islow.jpg ${TESTIMAGES}/testorig.ppm - ${MD5_JPEG_RGB_ISLOW}) - - # CC: null SAMP: fullsize IDCT: islow ENT: huff - add_bittest(djpeg rgb-islow "-dct;int;-ppm;-icc;testout_rgb_islow.icc" - testout_rgb_islow.ppm testout_rgb_islow.jpg - ${MD5_PPM_RGB_ISLOW} cjpeg-${libtype}-rgb-islow) - - add_test(djpeg-${libtype}-rgb-islow-icc-cmp - ${CMAKE_CROSSCOMPILING_EMULATOR} ${MD5CMP} - b06a39d730129122e85c1363ed1bbc9e testout_rgb_islow.icc) - set_tests_properties(djpeg-${libtype}-rgb-islow-icc-cmp PROPERTIES - DEPENDS djpeg-${libtype}-rgb-islow) - - add_bittest(jpegtran icc "-copy;all;-icc;${TESTIMAGES}/test2.icc" - testout_rgb_islow2.jpg testout_rgb_islow.jpg - ${MD5_JPEG_RGB_ISLOW2} cjpeg-${libtype}-rgb-islow) - - if(NOT WITH_12BIT) - # CC: RGB->RGB565 SAMP: fullsize IDCT: islow ENT: huff - add_bittest(djpeg rgb-islow-565 "-dct;int;-rgb565;-dither;none;-bmp" - testout_rgb_islow_565.bmp testout_rgb_islow.jpg - ${MD5_BMP_RGB_ISLOW_565} cjpeg-${libtype}-rgb-islow) - - # CC: RGB->RGB565 (dithered) SAMP: fullsize IDCT: islow ENT: huff - add_bittest(djpeg rgb-islow-565D "-dct;int;-rgb565;-bmp" - testout_rgb_islow_565D.bmp testout_rgb_islow.jpg - ${MD5_BMP_RGB_ISLOW_565D} cjpeg-${libtype}-rgb-islow) - endif() - - # CC: RGB->YCC SAMP: fullsize/h2v1 FDCT: ifast ENT: 2-pass huff - add_bittest(cjpeg 422-ifast-opt "-sample;2x1;-dct;fast;-opt" - testout_422_ifast_opt.jpg ${TESTIMAGES}/testorig.ppm - ${MD5_JPEG_422_IFAST_OPT}) - - # CC: YCC->RGB SAMP: fullsize/h2v1 fancy IDCT: ifast ENT: huff - add_bittest(djpeg 422-ifast "-dct;fast" - testout_422_ifast.ppm testout_422_ifast_opt.jpg - ${MD5_PPM_422_IFAST} cjpeg-${libtype}-422-ifast-opt) - - # CC: RGB->YCC SAMP: fullsize/h1v2 FDCT: islow ENT: huff - add_bittest(cjpeg 440-islow "-sample;1x2;-dct;int" - testout_440_islow.jpg ${TESTIMAGES}/testorig.ppm - ${MD5_JPEG_440_ISLOW}) - - # CC: YCC->RGB SAMP: fullsize/h1v2 fancy IDCT: islow ENT: huff - add_bittest(djpeg 440-islow "-dct;int" - testout_440_islow.ppm testout_440_islow.jpg - ${MD5_PPM_440_ISLOW} cjpeg-${libtype}-440-islow) - - # CC: YCC->RGB SAMP: h2v1 merged IDCT: ifast ENT: huff - add_bittest(djpeg 422m-ifast "-dct;fast;-nosmooth" - testout_422m_ifast.ppm testout_422_ifast_opt.jpg - ${MD5_PPM_422M_IFAST} cjpeg-${libtype}-422-ifast-opt) - - if(NOT WITH_12BIT) - # CC: YCC->RGB565 SAMP: h2v1 merged IDCT: ifast ENT: huff - add_bittest(djpeg 422m-ifast-565 - "-dct;int;-nosmooth;-rgb565;-dither;none;-bmp" - testout_422m_ifast_565.bmp testout_422_ifast_opt.jpg - ${MD5_BMP_422M_IFAST_565} cjpeg-${libtype}-422-ifast-opt) - - # CC: YCC->RGB565 (dithered) SAMP: h2v1 merged IDCT: ifast ENT: huff - add_bittest(djpeg 422m-ifast-565D "-dct;int;-nosmooth;-rgb565;-bmp" - testout_422m_ifast_565D.bmp testout_422_ifast_opt.jpg - ${MD5_BMP_422M_IFAST_565D} cjpeg-${libtype}-422-ifast-opt) - endif() - - # CC: RGB->YCC SAMP: fullsize/h2v2 FDCT: ifast ENT: prog huff - add_bittest(cjpeg 420-q100-ifast-prog - "-sample;2x2;-quality;100;-dct;fast;-scans;${TESTIMAGES}/test.scan" - testout_420_q100_ifast_prog.jpg ${TESTIMAGES}/testorig.ppm - ${MD5_JPEG_420_IFAST_Q100_PROG}) - - # CC: YCC->RGB SAMP: fullsize/h2v2 fancy IDCT: ifast ENT: prog huff - add_bittest(djpeg 420-q100-ifast-prog "-dct;fast" - testout_420_q100_ifast.ppm testout_420_q100_ifast_prog.jpg - ${MD5_PPM_420_Q100_IFAST} cjpeg-${libtype}-420-q100-ifast-prog) - - # CC: YCC->RGB SAMP: h2v2 merged IDCT: ifast ENT: prog huff - add_bittest(djpeg 420m-q100-ifast-prog "-dct;fast;-nosmooth" - testout_420m_q100_ifast.ppm testout_420_q100_ifast_prog.jpg - ${MD5_PPM_420M_Q100_IFAST} cjpeg-${libtype}-420-q100-ifast-prog) - - # CC: RGB->Gray SAMP: fullsize FDCT: islow ENT: huff - add_bittest(cjpeg gray-islow "-gray;-dct;int" - testout_gray_islow.jpg ${TESTIMAGES}/testorig.ppm - ${MD5_JPEG_GRAY_ISLOW}) - - # CC: Gray->Gray SAMP: fullsize IDCT: islow ENT: huff - add_bittest(djpeg gray-islow "-dct;int" - testout_gray_islow.ppm testout_gray_islow.jpg - ${MD5_PPM_GRAY_ISLOW} cjpeg-${libtype}-gray-islow) - - # CC: Gray->RGB SAMP: fullsize IDCT: islow ENT: huff - add_bittest(djpeg gray-islow-rgb "-dct;int;-rgb" - testout_gray_islow_rgb.ppm testout_gray_islow.jpg - ${MD5_PPM_GRAY_ISLOW_RGB} cjpeg-${libtype}-gray-islow) - - if(NOT WITH_12BIT) - # CC: Gray->RGB565 SAMP: fullsize IDCT: islow ENT: huff - add_bittest(djpeg gray-islow-565 "-dct;int;-rgb565;-dither;none;-bmp" - testout_gray_islow_565.bmp testout_gray_islow.jpg - ${MD5_BMP_GRAY_ISLOW_565} cjpeg-${libtype}-gray-islow) - - # CC: Gray->RGB565 (dithered) SAMP: fullsize IDCT: islow ENT: huff - add_bittest(djpeg gray-islow-565D "-dct;int;-rgb565;-bmp" - testout_gray_islow_565D.bmp testout_gray_islow.jpg - ${MD5_BMP_GRAY_ISLOW_565D} cjpeg-${libtype}-gray-islow) - endif() - - # CC: RGB->YCC SAMP: fullsize smooth/h2v2 smooth FDCT: islow - # ENT: 2-pass huff - add_bittest(cjpeg 420s-ifast-opt "-sample;2x2;-smooth;1;-dct;int;-opt" - testout_420s_ifast_opt.jpg ${TESTIMAGES}/testorig.ppm - ${MD5_JPEG_420S_IFAST_OPT}) - - if(FLOATTEST) - # CC: RGB->YCC SAMP: fullsize/int FDCT: float ENT: prog huff - add_bittest(cjpeg 3x2-float-prog "-sample;3x2;-dct;float;-prog" - testout_3x2_float_prog.jpg ${TESTIMAGES}/testorig.ppm - ${MD5_JPEG_3x2_FLOAT_PROG_${FLOATTEST_UC}}) - - # CC: YCC->RGB SAMP: fullsize/int IDCT: float ENT: prog huff - add_bittest(djpeg 3x2-float-prog "-dct;float" - testout_3x2_float.ppm testout_3x2_float_prog.jpg - ${MD5_PPM_3x2_FLOAT_${FLOATTEST_UC}} cjpeg-${libtype}-3x2-float-prog) - endif() - - # CC: RGB->YCC SAMP: fullsize/int FDCT: ifast ENT: prog huff - add_bittest(cjpeg 3x2-ifast-prog "-sample;3x2;-dct;fast;-prog" - testout_3x2_ifast_prog.jpg ${TESTIMAGES}/testorig.ppm - ${MD5_JPEG_3x2_IFAST_PROG}) - - # CC: YCC->RGB SAMP: fullsize/int IDCT: ifast ENT: prog huff - add_bittest(djpeg 3x2-ifast-prog "-dct;fast" - testout_3x2_ifast.ppm testout_3x2_ifast_prog.jpg - ${MD5_PPM_3x2_IFAST} cjpeg-${libtype}-3x2-ifast-prog) - - if(WITH_ARITH_ENC) - # CC: YCC->RGB SAMP: fullsize/h2v2 FDCT: islow ENT: arith - add_bittest(cjpeg 420-islow-ari "-dct;int;-arithmetic" - testout_420_islow_ari.jpg ${TESTIMAGES}/testorig.ppm - ${MD5_JPEG_420_ISLOW_ARI}) - - add_bittest(jpegtran 420-islow-ari "-arithmetic" - testout_420_islow_ari2.jpg ${TESTIMAGES}/testimgint.jpg - ${MD5_JPEG_420_ISLOW_ARI}) - - # CC: YCC->RGB SAMP: fullsize FDCT: islow ENT: prog arith - add_bittest(cjpeg 444-islow-progari - "-sample;1x1;-dct;int;-prog;-arithmetic" - testout_444_islow_progari.jpg ${TESTIMAGES}/testorig.ppm - ${MD5_JPEG_444_ISLOW_PROGARI}) - endif() - - if(WITH_ARITH_DEC) - # CC: RGB->YCC SAMP: h2v2 merged IDCT: ifast ENT: arith - add_bittest(djpeg 420m-ifast-ari "-fast;-skip;1,20;-ppm" - testout_420m_ifast_ari.ppm ${TESTIMAGES}/testimgari.jpg - ${MD5_PPM_420M_IFAST_ARI}) - - add_bittest(jpegtran 420-islow "" - testout_420_islow.jpg ${TESTIMAGES}/testimgari.jpg - ${MD5_JPEG_420_ISLOW}) - endif() - - # 2/1-- CC: YCC->RGB SAMP: h2v2 merged IDCT: 16x16 islow ENT: huff - # 15/8-- CC: YCC->RGB SAMP: h2v2 merged IDCT: 15x15 islow ENT: huff - # 13/8-- CC: YCC->RGB SAMP: h2v2 merged IDCT: 13x13 islow ENT: huff - # 11/8-- CC: YCC->RGB SAMP: h2v2 merged IDCT: 11x11 islow ENT: huff - # 9/8-- CC: YCC->RGB SAMP: h2v2 merged IDCT: 9x9 islow ENT: huff - # 7/8-- CC: YCC->RGB SAMP: h2v2 merged IDCT: 7x7 islow/14x14 islow - # ENT: huff - # 3/4-- CC: YCC->RGB SAMP: h2v2 merged IDCT: 6x6 islow/12x12 islow - # ENT: huff - # 5/8-- CC: YCC->RGB SAMP: h2v2 merged IDCT: 5x5 islow/10x10 islow - # ENT: huff - # 1/2-- CC: YCC->RGB SAMP: h2v2 merged IDCT: 4x4 islow/8x8 islow - # ENT: huff - # 3/8-- CC: YCC->RGB SAMP: h2v2 merged IDCT: 3x3 islow/6x6 islow - # ENT: huff - # 1/4-- CC: YCC->RGB SAMP: h2v2 merged IDCT: 2x2 islow/4x4 islow - # ENT: huff - # 1/8-- CC: YCC->RGB SAMP: h2v2 merged IDCT: 1x1 islow/2x2 islow - # ENT: huff - foreach(scale 2_1 15_8 13_8 11_8 9_8 7_8 3_4 5_8 1_2 3_8 1_4 1_8) - string(REGEX REPLACE "_" "/" scalearg ${scale}) - add_bittest(djpeg 420m-islow-${scale} - "-dct;int;-scale;${scalearg};-nosmooth;-ppm" - testout_420m_islow_${scale}.ppm ${TESTIMAGES}/${TESTORIG} - ${MD5_PPM_420M_ISLOW_${scale}}) - endforeach() - - if(NOT WITH_12BIT) - # CC: YCC->RGB (dithered) SAMP: h2v2 fancy IDCT: islow ENT: huff - add_bittest(djpeg 420-islow-256 "-dct;int;-colors;256;-bmp" - testout_420_islow_256.bmp ${TESTIMAGES}/${TESTORIG} - ${MD5_BMP_420_ISLOW_256}) - - # CC: YCC->RGB565 SAMP: h2v2 fancy IDCT: islow ENT: huff - add_bittest(djpeg 420-islow-565 "-dct;int;-rgb565;-dither;none;-bmp" - testout_420_islow_565.bmp ${TESTIMAGES}/${TESTORIG} - ${MD5_BMP_420_ISLOW_565}) - - # CC: YCC->RGB565 (dithered) SAMP: h2v2 fancy IDCT: islow ENT: huff - add_bittest(djpeg 420-islow-565D "-dct;int;-rgb565;-bmp" - testout_420_islow_565D.bmp ${TESTIMAGES}/${TESTORIG} - ${MD5_BMP_420_ISLOW_565D}) - - # CC: YCC->RGB565 SAMP: h2v2 merged IDCT: islow ENT: huff - add_bittest(djpeg 420m-islow-565 - "-dct;int;-nosmooth;-rgb565;-dither;none;-bmp" - testout_420m_islow_565.bmp ${TESTIMAGES}/${TESTORIG} - ${MD5_BMP_420M_ISLOW_565}) - - # CC: YCC->RGB565 (dithered) SAMP: h2v2 merged IDCT: islow ENT: huff - add_bittest(djpeg 420m-islow-565D "-dct;int;-nosmooth;-rgb565;-bmp" - testout_420m_islow_565D.bmp ${TESTIMAGES}/${TESTORIG} - ${MD5_BMP_420M_ISLOW_565D}) - endif() - - # Partial decode tests. These tests are designed to cover all of the - # possible code paths in jpeg_skip_scanlines(). - - # Context rows: Yes Intra-iMCU row: Yes iMCU row prefetch: No ENT: huff - add_bittest(djpeg 420-islow-skip15_31 "-dct;int;-skip;15,31;-ppm" - testout_420_islow_skip15,31.ppm ${TESTIMAGES}/${TESTORIG} - ${MD5_PPM_420_ISLOW_SKIP15_31}) - - # Context rows: Yes Intra-iMCU row: No iMCU row prefetch: Yes ENT: arith - if(WITH_ARITH_DEC) - add_bittest(djpeg 420-islow-ari-skip16_139 "-dct;int;-skip;16,139;-ppm" - testout_420_islow_ari_skip16,139.ppm ${TESTIMAGES}/testimgari.jpg - ${MD5_PPM_420_ISLOW_ARI_SKIP16_139}) - endif() - - # Context rows: Yes Intra-iMCU row: No iMCU row prefetch: No ENT: prog huff - add_test(cjpeg-${libtype}-420-islow-prog - ${CMAKE_CROSSCOMPILING_EMULATOR} cjpeg${suffix} -dct int -prog - -outfile testout_420_islow_prog.jpg ${TESTIMAGES}/testorig.ppm) - add_bittest(djpeg 420-islow-prog-crop62x62_71_71 - "-dct;int;-crop;62x62+71+71;-ppm" - testout_420_islow_prog_crop62x62,71,71.ppm testout_420_islow_prog.jpg - ${MD5_PPM_420_ISLOW_PROG_CROP62x62_71_71} cjpeg-${libtype}-420-islow-prog) - - # Context rows: Yes Intra-iMCU row: No iMCU row prefetch: No ENT: arith - if(WITH_ARITH_DEC) - add_bittest(djpeg 420-islow-ari-crop53x53_4_4 - "-dct;int;-crop;53x53+4+4;-ppm" - testout_420_islow_ari_crop53x53,4,4.ppm ${TESTIMAGES}/testimgari.jpg - ${MD5_PPM_420_ISLOW_ARI_CROP53x53_4_4}) - endif() - - # Context rows: No Intra-iMCU row: Yes ENT: huff - add_test(cjpeg-${libtype}-444-islow - ${CMAKE_CROSSCOMPILING_EMULATOR} cjpeg${suffix} -dct int -sample 1x1 - -outfile testout_444_islow.jpg ${TESTIMAGES}/testorig.ppm) - add_bittest(djpeg 444-islow-skip1_6 "-dct;int;-skip;1,6;-ppm" - testout_444_islow_skip1,6.ppm testout_444_islow.jpg - ${MD5_PPM_444_ISLOW_SKIP1_6} cjpeg-${libtype}-444-islow) - - # Context rows: No Intra-iMCU row: No ENT: prog huff - add_test(cjpeg-${libtype}-444-islow-prog - ${CMAKE_CROSSCOMPILING_EMULATOR} cjpeg${suffix} -dct int -prog -sample 1x1 - -outfile testout_444_islow_prog.jpg ${TESTIMAGES}/testorig.ppm) - add_bittest(djpeg 444-islow-prog-crop98x98_13_13 - "-dct;int;-crop;98x98+13+13;-ppm" - testout_444_islow_prog_crop98x98,13,13.ppm testout_444_islow_prog.jpg - ${MD5_PPM_444_ISLOW_PROG_CROP98x98_13_13} cjpeg-${libtype}-444-islow-prog) - - # Context rows: No Intra-iMCU row: No ENT: arith - if(WITH_ARITH_ENC) - add_test(cjpeg-${libtype}-444-islow-ari - ${CMAKE_CROSSCOMPILING_EMULATOR} cjpeg${suffix} -dct int -arithmetic - -sample 1x1 -outfile testout_444_islow_ari.jpg - ${TESTIMAGES}/testorig.ppm) - if(WITH_ARITH_DEC) - add_bittest(djpeg 444-islow-ari-crop37x37_0_0 - "-dct;int;-crop;37x37+0+0;-ppm" - testout_444_islow_ari_crop37x37,0,0.ppm testout_444_islow_ari.jpg - ${MD5_PPM_444_ISLOW_ARI_CROP37x37_0_0} cjpeg-${libtype}-444-islow-ari) - endif() - endif() - - add_bittest(jpegtran crop "-crop;120x90+20+50;-transpose;-perfect" - testout_crop.jpg ${TESTIMAGES}/${TESTORIG} - ${MD5_JPEG_CROP}) - -endforeach() - -add_custom_target(testclean COMMAND ${CMAKE_COMMAND} -P - ${CMAKE_CURRENT_SOURCE_DIR}/cmakescripts/testclean.cmake) - -configure_file(croptest.in croptest @ONLY) -add_custom_target(croptest - COMMAND echo croptest - COMMAND ${BASH} ${CMAKE_CURRENT_BINARY_DIR}/croptest) - -if(WITH_TURBOJPEG) - configure_file(tjbenchtest.in tjbenchtest @ONLY) - configure_file(tjexampletest.in tjexampletest @ONLY) - if(WIN32) - set(BASH bash) - endif() - if(WITH_JAVA) - configure_file(tjbenchtest.java.in tjbenchtest.java @ONLY) - configure_file(tjexampletest.java.in tjexampletest.java @ONLY) - add_custom_target(tjtest - COMMAND echo tjbenchtest - COMMAND ${BASH} ${CMAKE_CURRENT_BINARY_DIR}/tjbenchtest - COMMAND echo tjbenchtest -alloc - COMMAND ${BASH} ${CMAKE_CURRENT_BINARY_DIR}/tjbenchtest -alloc - COMMAND echo tjbenchtest -yuv - COMMAND ${BASH} ${CMAKE_CURRENT_BINARY_DIR}/tjbenchtest -yuv - COMMAND echo tjbenchtest -yuv -alloc - COMMAND ${BASH} ${CMAKE_CURRENT_BINARY_DIR}/tjbenchtest -yuv -alloc - COMMAND echo tjbenchtest -progressive - COMMAND ${BASH} ${CMAKE_CURRENT_BINARY_DIR}/tjbenchtest -progressive - COMMAND echo tjbenchtest -progressive -yuv - COMMAND ${BASH} ${CMAKE_CURRENT_BINARY_DIR}/tjbenchtest -progressive -yuv - COMMAND echo tjexampletest - COMMAND ${BASH} ${CMAKE_CURRENT_BINARY_DIR}/tjexampletest - COMMAND echo tjbenchtest.java - COMMAND ${BASH} ${CMAKE_CURRENT_BINARY_DIR}/tjbenchtest.java - COMMAND echo tjbenchtest.java -yuv - COMMAND ${BASH} ${CMAKE_CURRENT_BINARY_DIR}/tjbenchtest.java -yuv - COMMAND echo tjbenchtest.java -progressive - COMMAND ${BASH} ${CMAKE_CURRENT_BINARY_DIR}/tjbenchtest.java -progressive - COMMAND echo tjexampletest.java -progressive -yuv - COMMAND ${BASH} ${CMAKE_CURRENT_BINARY_DIR}/tjbenchtest.java - -progressive -yuv - COMMAND echo tjexampletest.java - COMMAND ${BASH} ${CMAKE_CURRENT_BINARY_DIR}/tjexampletest.java - DEPENDS ${CMAKE_CURRENT_BINARY_DIR}/tjbenchtest - ${CMAKE_CURRENT_BINARY_DIR}/tjbenchtest.java - ${CMAKE_CURRENT_BINARY_DIR}/tjexampletest) - else() - add_custom_target(tjtest - COMMAND echo tjbenchtest - COMMAND ${BASH} ${CMAKE_CURRENT_BINARY_DIR}/tjbenchtest - COMMAND echo tjbenchtest -alloc - COMMAND ${BASH} ${CMAKE_CURRENT_BINARY_DIR}/tjbenchtest -alloc - COMMAND echo tjbenchtest -yuv - COMMAND ${BASH} ${CMAKE_CURRENT_BINARY_DIR}/tjbenchtest -yuv - COMMAND echo tjbenchtest -yuv -alloc - COMMAND ${BASH} ${CMAKE_CURRENT_BINARY_DIR}/tjbenchtest -yuv -alloc - COMMAND echo tjbenchtest -progressive - COMMAND ${BASH} ${CMAKE_CURRENT_BINARY_DIR}/tjbenchtest -progressive - COMMAND echo tjbenchtest -progressive -yuv - COMMAND ${BASH} ${CMAKE_CURRENT_BINARY_DIR}/tjbenchtest -progressive -yuv - COMMAND echo tjexampletest - COMMAND ${BASH} ${CMAKE_CURRENT_BINARY_DIR}/tjexampletest - DEPENDS ${CMAKE_CURRENT_BINARY_DIR}/tjbenchtest) - endif() -endif() - - -############################################################################### -# INSTALLATION -############################################################################### - -set(EXE ${CMAKE_EXECUTABLE_SUFFIX}) - -if(WITH_TURBOJPEG) - if(ENABLE_SHARED) - install(TARGETS turbojpeg EXPORT ${CMAKE_PROJECT_NAME}Targets - INCLUDES DESTINATION ${CMAKE_INSTALL_INCLUDEDIR} - ARCHIVE DESTINATION ${CMAKE_INSTALL_LIBDIR} - LIBRARY DESTINATION ${CMAKE_INSTALL_LIBDIR} - RUNTIME DESTINATION ${CMAKE_INSTALL_BINDIR}) - install(TARGETS tjbench - RUNTIME DESTINATION ${CMAKE_INSTALL_BINDIR}) - if(NOT CMAKE_VERSION VERSION_LESS "3.1" AND MSVC AND - CMAKE_C_LINKER_SUPPORTS_PDB) - install(FILES "$" - DESTINATION ${CMAKE_INSTALL_BINDIR} OPTIONAL) - endif() - endif() - if(ENABLE_STATIC) - install(TARGETS turbojpeg-static EXPORT ${CMAKE_PROJECT_NAME}Targets - INCLUDES DESTINATION ${CMAKE_INSTALL_INCLUDEDIR} - ARCHIVE DESTINATION ${CMAKE_INSTALL_LIBDIR}) - if(NOT ENABLE_SHARED) - if(MSVC_IDE OR XCODE) - set(DIR "${CMAKE_CURRENT_BINARY_DIR}/\${CMAKE_INSTALL_CONFIG_NAME}") - else() - set(DIR ${CMAKE_CURRENT_BINARY_DIR}) - endif() - install(PROGRAMS ${DIR}/tjbench-static${EXE} - DESTINATION ${CMAKE_INSTALL_BINDIR} RENAME tjbench${EXE}) - endif() - endif() - install(FILES ${CMAKE_CURRENT_SOURCE_DIR}/turbojpeg.h - DESTINATION ${CMAKE_INSTALL_INCLUDEDIR}) -endif() - -if(ENABLE_STATIC) - install(TARGETS jpeg-static EXPORT ${CMAKE_PROJECT_NAME}Targets - INCLUDES DESTINATION ${CMAKE_INSTALL_INCLUDEDIR} - ARCHIVE DESTINATION ${CMAKE_INSTALL_LIBDIR}) - if(NOT ENABLE_SHARED) - if(MSVC_IDE OR XCODE) - set(DIR "${CMAKE_CURRENT_BINARY_DIR}/\${CMAKE_INSTALL_CONFIG_NAME}") - else() - set(DIR ${CMAKE_CURRENT_BINARY_DIR}) - endif() - install(PROGRAMS ${DIR}/cjpeg-static${EXE} - DESTINATION ${CMAKE_INSTALL_BINDIR} RENAME cjpeg${EXE}) - install(PROGRAMS ${DIR}/djpeg-static${EXE} - DESTINATION ${CMAKE_INSTALL_BINDIR} RENAME djpeg${EXE}) - install(PROGRAMS ${DIR}/jpegtran-static${EXE} - DESTINATION ${CMAKE_INSTALL_BINDIR} RENAME jpegtran${EXE}) - endif() -endif() - -install(TARGETS rdjpgcom wrjpgcom RUNTIME DESTINATION ${CMAKE_INSTALL_BINDIR}) - -install(FILES ${CMAKE_CURRENT_SOURCE_DIR}/README.ijg - ${CMAKE_CURRENT_SOURCE_DIR}/README.md ${CMAKE_CURRENT_SOURCE_DIR}/example.txt - ${CMAKE_CURRENT_SOURCE_DIR}/tjexample.c - ${CMAKE_CURRENT_SOURCE_DIR}/libjpeg.txt - ${CMAKE_CURRENT_SOURCE_DIR}/structure.txt - ${CMAKE_CURRENT_SOURCE_DIR}/usage.txt ${CMAKE_CURRENT_SOURCE_DIR}/wizard.txt - ${CMAKE_CURRENT_SOURCE_DIR}/LICENSE.md DESTINATION ${CMAKE_INSTALL_DOCDIR}) -if(WITH_JAVA) - install(FILES ${CMAKE_CURRENT_SOURCE_DIR}/java/TJExample.java - DESTINATION ${CMAKE_INSTALL_DOCDIR}) -endif() - -if(UNIX OR MINGW) - install(FILES ${CMAKE_CURRENT_SOURCE_DIR}/cjpeg.1 - ${CMAKE_CURRENT_SOURCE_DIR}/djpeg.1 ${CMAKE_CURRENT_SOURCE_DIR}/jpegtran.1 - ${CMAKE_CURRENT_SOURCE_DIR}/rdjpgcom.1 - ${CMAKE_CURRENT_SOURCE_DIR}/wrjpgcom.1 - DESTINATION ${CMAKE_INSTALL_MANDIR}/man1) -endif() -install(FILES ${CMAKE_CURRENT_BINARY_DIR}/pkgscripts/libjpeg.pc - ${CMAKE_CURRENT_BINARY_DIR}/pkgscripts/libturbojpeg.pc - DESTINATION ${CMAKE_INSTALL_LIBDIR}/pkgconfig) -install(FILES - ${CMAKE_CURRENT_BINARY_DIR}/pkgscripts/${CMAKE_PROJECT_NAME}Config.cmake - ${CMAKE_CURRENT_BINARY_DIR}/pkgscripts/${CMAKE_PROJECT_NAME}ConfigVersion.cmake - DESTINATION ${CMAKE_INSTALL_LIBDIR}/cmake/${CMAKE_PROJECT_NAME}) -install(EXPORT ${CMAKE_PROJECT_NAME}Targets - NAMESPACE ${CMAKE_PROJECT_NAME}:: - DESTINATION ${CMAKE_INSTALL_LIBDIR}/cmake/${CMAKE_PROJECT_NAME}) - -install(FILES ${CMAKE_CURRENT_BINARY_DIR}/jconfig.h - ${CMAKE_CURRENT_SOURCE_DIR}/jerror.h ${CMAKE_CURRENT_SOURCE_DIR}/jmorecfg.h - ${CMAKE_CURRENT_SOURCE_DIR}/jpeglib.h - DESTINATION ${CMAKE_INSTALL_INCLUDEDIR}) - -include(cmakescripts/BuildPackages.cmake) - -configure_file("${CMAKE_CURRENT_SOURCE_DIR}/cmakescripts/cmake_uninstall.cmake.in" - "cmake_uninstall.cmake" IMMEDIATE @ONLY) - -add_custom_target(uninstall COMMAND ${CMAKE_COMMAND} -P cmake_uninstall.cmake) +endif() \ No newline at end of file diff --git a/cmake/CMakeLists.png b/cmake/CMakeLists.png new file mode 100644 index 0000000000..2521ab41be --- /dev/null +++ b/cmake/CMakeLists.png @@ -0,0 +1,741 @@ +# CMakeLists.txt + +# Copyright (C) 2018 Cosmin Truta +# Copyright (C) 2007,2009-2018 Glenn Randers-Pehrson +# Written by Christian Ehrlicher, 2007 +# Revised by Roger Lowman, 2009-2010 +# Revised by Clifford Yapp, 2011-2012,2017 +# Revised by Roger Leigh, 2016 +# Revised by Andreas Franek, 2016 +# Revised by Sam Serrels, 2017 +# Revised by Vadim Barkov, 2017 +# Revised by Vicky Pfau, 2018 +# Revised by Cameron Cawley, 2018 +# Revised by Cosmin Truta, 2018 +# Revised by Kyle Bentley, 2018 + +# This code is released under the libpng license. +# For conditions of distribution and use, see the disclaimer +# and license in png.h + +cmake_minimum_required(VERSION 3.10) +cmake_policy(VERSION 3.1) +# When using CMake 3.4 and later, don't export symbols from executables unless +# the CMAKE_ENABLE_EXPORTS variable is set. +if(POLICY CMP0065) + cmake_policy(SET CMP0065 NEW) +endif() +if (POLICY CMP0077) + cmake_policy(SET CMP0077 NEW) +endif() +set(CMAKE_ALLOW_LOOSE_LOOP_CONSTRUCTS ON) + +project(libpng C ASM) +enable_testing() + +set(PNGLIB_MAJOR 1) +set(PNGLIB_MINOR 6) +set(PNGLIB_RELEASE 37) +set(PNGLIB_NAME libpng${PNGLIB_MAJOR}${PNGLIB_MINOR}) +set(PNGLIB_VERSION ${PNGLIB_MAJOR}.${PNGLIB_MINOR}.${PNGLIB_RELEASE}) + +include(GNUInstallDirs) + +# needed packages + +# Allow users to specify location of Zlib. +# Useful if zlib is being built alongside this as a sub-project. +option(PNG_BUILD_ZLIB "Custom zlib Location, else find_package is used" ON) + +if(NOT PNG_BUILD_ZLIB) + find_package(ZLIB REQUIRED) + include_directories(${ZLIB_INCLUDE_DIR}) +endif() + +if(UNIX AND NOT APPLE AND NOT BEOS AND NOT HAIKU) + find_library(M_LIBRARY m) +else() + # libm is not needed and/or not available + set(M_LIBRARY "") +endif() + +# COMMAND LINE OPTIONS +option(PNG_SHARED "Build shared lib" OFF) +option(PNG_STATIC "Build static lib" ON) +option(PNG_TESTS "Build libpng tests" OFF) + +# Many more configuration options could be added here +option(PNG_FRAMEWORK "Build OS X framework" OFF) +option(PNG_DEBUG "Build with debug output" OFF) +option(PNG_HARDWARE_OPTIMIZATIONS "Enable hardware optimizations" OFF) + +set(PNG_PREFIX "" CACHE STRING "Prefix to add to the API function names") +set(DFA_XTRA "" CACHE FILEPATH "File containing extra configuration settings") + +if(PNG_HARDWARE_OPTIMIZATIONS) + +# set definitions and sources for arm +if(CMAKE_SYSTEM_PROCESSOR MATCHES "^arm" OR + CMAKE_SYSTEM_PROCESSOR MATCHES "^aarch64") + set(PNG_ARM_NEON_POSSIBLE_VALUES check on off) + set(PNG_ARM_NEON "check" CACHE STRING "Enable ARM NEON optimizations: + check: (default) use internal checking code; + off: disable the optimizations; + on: turn on unconditionally.") + set_property(CACHE PNG_ARM_NEON PROPERTY STRINGS + ${PNG_ARM_NEON_POSSIBLE_VALUES}) + list(FIND PNG_ARM_NEON_POSSIBLE_VALUES ${PNG_ARM_NEON} index) + if(index EQUAL -1) + message(FATAL_ERROR + "PNG_ARM_NEON must be one of [${PNG_ARM_NEON_POSSIBLE_VALUES}]") + elseif(NOT ${PNG_ARM_NEON} STREQUAL "off") + set(libpng_arm_sources + arm/arm_init.c + arm/filter_neon.S + arm/filter_neon_intrinsics.c + arm/palette_neon_intrinsics.c) + + if(${PNG_ARM_NEON} STREQUAL "on") + add_definitions(-DPNG_ARM_NEON_OPT=2) + elseif(${PNG_ARM_NEON} STREQUAL "check") + add_definitions(-DPNG_ARM_NEON_CHECK_SUPPORTED) + endif() + else() + add_definitions(-DPNG_ARM_NEON_OPT=0) + endif() +endif() + +# set definitions and sources for powerpc +if(CMAKE_SYSTEM_PROCESSOR MATCHES "^powerpc*" OR + CMAKE_SYSTEM_PROCESSOR MATCHES "^ppc64*") + set(PNG_POWERPC_VSX_POSSIBLE_VALUES on off) + set(PNG_POWERPC_VSX "on" CACHE STRING "Enable POWERPC VSX optimizations: + off: disable the optimizations.") + set_property(CACHE PNG_POWERPC_VSX PROPERTY STRINGS + ${PNG_POWERPC_VSX_POSSIBLE_VALUES}) + list(FIND PNG_POWERPC_VSX_POSSIBLE_VALUES ${PNG_POWERPC_VSX} index) + if(index EQUAL -1) + message(FATAL_ERROR + "PNG_POWERPC_VSX must be one of [${PNG_POWERPC_VSX_POSSIBLE_VALUES}]") + elseif(NOT ${PNG_POWERPC_VSX} STREQUAL "off") + set(libpng_powerpc_sources + powerpc/powerpc_init.c + powerpc/filter_vsx_intrinsics.c) + if(${PNG_POWERPC_VSX} STREQUAL "on") + add_definitions(-DPNG_POWERPC_VSX_OPT=2) + endif() + else() + add_definitions(-DPNG_POWERPC_VSX_OPT=0) + endif() +endif() + +# set definitions and sources for intel +if(CMAKE_SYSTEM_PROCESSOR MATCHES "^i?86" OR + CMAKE_SYSTEM_PROCESSOR MATCHES "^x86_64*") + set(PNG_INTEL_SSE_POSSIBLE_VALUES on off) + set(PNG_INTEL_SSE "on" CACHE STRING "Enable INTEL_SSE optimizations: + off: disable the optimizations") + set_property(CACHE PNG_INTEL_SSE PROPERTY STRINGS + ${PNG_INTEL_SSE_POSSIBLE_VALUES}) + list(FIND PNG_INTEL_SSE_POSSIBLE_VALUES ${PNG_INTEL_SSE} index) + if(index EQUAL -1) + message(FATAL_ERROR + "PNG_INTEL_SSE must be one of [${PNG_INTEL_SSE_POSSIBLE_VALUES}]") + elseif(NOT ${PNG_INTEL_SSE} STREQUAL "off") + set(libpng_intel_sources + intel/intel_init.c + intel/filter_sse2_intrinsics.c) + if(${PNG_INTEL_SSE} STREQUAL "on") + add_definitions(-DPNG_INTEL_SSE_OPT=1) + endif() + else() + add_definitions(-DPNG_INTEL_SSE_OPT=0) + endif() +endif() + +# set definitions and sources for MIPS +if(CMAKE_SYSTEM_PROCESSOR MATCHES "mipsel*" OR + CMAKE_SYSTEM_PROCESSOR MATCHES "mips64el*") + set(PNG_MIPS_MSA_POSSIBLE_VALUES on off) + set(PNG_MIPS_MSA "on" CACHE STRING "Enable MIPS_MSA optimizations: + off: disable the optimizations") + set_property(CACHE PNG_MIPS_MSA PROPERTY STRINGS + ${PNG_MIPS_MSA_POSSIBLE_VALUES}) + list(FIND PNG_MIPS_MSA_POSSIBLE_VALUES ${PNG_MIPS_MSA} index) + if(index EQUAL -1) + message(FATAL_ERROR + "PNG_MIPS_MSA must be one of [${PNG_MIPS_MSA_POSSIBLE_VALUES}]") + elseif(NOT ${PNG_MIPS_MSA} STREQUAL "off") + set(libpng_mips_sources + mips/mips_init.c + mips/filter_msa_intrinsics.c) + if(${PNG_MIPS_MSA} STREQUAL "on") + add_definitions(-DPNG_MIPS_MSA_OPT=2) + endif() + else() + add_definitions(-DPNG_MIPS_MSA_OPT=0) + endif() +endif() + +else(PNG_HARDWARE_OPTIMIZATIONS) + +# set definitions and sources for arm +if(CMAKE_SYSTEM_PROCESSOR MATCHES "^arm" OR + CMAKE_SYSTEM_PROCESSOR MATCHES "^aarch64") + add_definitions(-DPNG_ARM_NEON_OPT=0) +endif() + +# set definitions and sources for powerpc +if(CMAKE_SYSTEM_PROCESSOR MATCHES "^powerpc*" OR + CMAKE_SYSTEM_PROCESSOR MATCHES "^ppc64*") + add_definitions(-DPNG_POWERPC_VSX_OPT=0) +endif() + +# set definitions and sources for intel +if(CMAKE_SYSTEM_PROCESSOR MATCHES "^i?86" OR + CMAKE_SYSTEM_PROCESSOR MATCHES "^x86_64*") + add_definitions(-DPNG_INTEL_SSE_OPT=0) +endif() + +# set definitions and sources for MIPS +if(CMAKE_SYSTEM_PROCESSOR MATCHES "mipsel*" OR + CMAKE_SYSTEM_PROCESSOR MATCHES "mips64el*") + add_definitions(-DPNG_MIPS_MSA_OPT=0) +endif() + +endif(PNG_HARDWARE_OPTIMIZATIONS) + +# SET LIBNAME +set(PNG_LIB_NAME png${PNGLIB_MAJOR}${PNGLIB_MINOR}) + +# to distinguish between debug and release lib +set(CMAKE_DEBUG_POSTFIX "d") + +include(CheckCSourceCompiles) +option(ld-version-script "Enable linker version script" ON) +if(ld-version-script AND NOT APPLE) + # Check if LD supports linker scripts. + file(WRITE "${CMAKE_CURRENT_BINARY_DIR}/conftest.map" "VERS_1 { + global: sym; + local: *; +}; + +VERS_2 { + global: sym2; + main; +} VERS_1; +") + set(CMAKE_REQUIRED_FLAGS_SAVE ${CMAKE_REQUIRED_FLAGS}) + set(CMAKE_REQUIRED_FLAGS ${CMAKE_REQUIRED_FLAGS} "-Wl,--version-script='${CMAKE_CURRENT_BINARY_DIR}/conftest.map'") + check_c_source_compiles("void sym(void) {} +void sym2(void) {} +int main(void) {return 0;} +" HAVE_LD_VERSION_SCRIPT) + if(NOT HAVE_LD_VERSION_SCRIPT) + set(CMAKE_REQUIRED_FLAGS ${CMAKE_REQUIRED_FLAGS_SAVE} "-Wl,-M -Wl,${CMAKE_CURRENT_BINARY_DIR}/conftest.map") + check_c_source_compiles("void sym(void) {} +void sym2(void) {} +int main(void) {return 0;} +" HAVE_SOLARIS_LD_VERSION_SCRIPT) + endif() + set(CMAKE_REQUIRED_FLAGS ${CMAKE_REQUIRED_FLAGS_SAVE}) + file(REMOVE "${CMAKE_CURRENT_BINARY_DIR}/conftest.map") +endif() + +# Find symbol prefix. Likely obsolete and unnecessary with recent +# toolchains (it's not done in many other projects). +function(symbol_prefix) + set(SYMBOL_PREFIX) + + execute_process(COMMAND "${CMAKE_C_COMPILER}" "-E" "-" + INPUT_FILE /dev/null + OUTPUT_VARIABLE OUT + RESULT_VARIABLE STATUS) + + if(CPP_FAIL) + message(WARNING "Failed to run the C preprocessor") + endif() + + string(REPLACE "\n" ";" OUT "${OUT}") + foreach(line ${OUT}) + string(REGEX MATCH "^PREFIX=" found_match "${line}") + if(found_match) + string(REGEX REPLACE "^PREFIX=(.*\)" "\\1" prefix "${line}") + string(REGEX MATCH "__USER_LABEL_PREFIX__" found_match "${prefix}") + if(found_match) + string(REGEX REPLACE "(.*)__USER_LABEL_PREFIX__(.*)" "\\1\\2" prefix "${prefix}") + endif() + set(SYMBOL_PREFIX "${prefix}") + endif() + endforeach() + + message(STATUS "Symbol prefix: ${SYMBOL_PREFIX}") + set(SYMBOL_PREFIX "${SYMBOL_PREFIX}" PARENT_SCOPE) +endfunction() + +if(UNIX) + symbol_prefix() +endif() + +find_program(AWK NAMES gawk awk) + +include_directories(${CMAKE_CURRENT_BINARY_DIR}) + +if(NOT AWK OR ANDROID) + # No awk available to generate sources; use pre-built pnglibconf.h + configure_file(${CMAKE_CURRENT_SOURCE_DIR}/scripts/pnglibconf.h.prebuilt + ${CMAKE_CURRENT_BINARY_DIR}/pnglibconf.h) + add_custom_target(genfiles) # Dummy +else() + include(CMakeParseArguments) + # Generate .chk from .out with awk + # generate_chk(INPUT inputfile OUTPUT outputfile [DEPENDS dep1 [dep2...]]) + function(generate_chk) + set(options) + set(oneValueArgs INPUT OUTPUT) + set(multiValueArgs DEPENDS) + cmake_parse_arguments(_GC "${options}" "${oneValueArgs}" "${multiValueArgs}" ${ARGN}) + if(NOT _GC_INPUT) + message(FATAL_ERROR "generate_chk: Missing INPUT argument") + endif() + if(NOT _GC_OUTPUT) + message(FATAL_ERROR "generate_chk: Missing OUTPUT argument") + endif() + + add_custom_command(OUTPUT "${_GC_OUTPUT}" + COMMAND "${CMAKE_COMMAND}" + "-DINPUT=${_GC_INPUT}" + "-DOUTPUT=${_GC_OUTPUT}" + -P "${CMAKE_CURRENT_BINARY_DIR}/scripts/genchk.cmake" + DEPENDS "${_GC_INPUT}" ${_GC_DEPENDS} + WORKING_DIRECTORY "${CMAKE_CURRENT_BINARY_DIR}") + endfunction() + + # Generate .out from .c with awk + # generate_out(INPUT inputfile OUTPUT outputfile [DEPENDS dep1 [dep2...]]) + function(generate_out) + set(options) + set(oneValueArgs INPUT OUTPUT) + set(multiValueArgs DEPENDS) + cmake_parse_arguments(_GO "${options}" "${oneValueArgs}" "${multiValueArgs}" ${ARGN}) + if(NOT _GO_INPUT) + message(FATAL_ERROR "generate_out: Missing INPUT argument") + endif() + if(NOT _GO_OUTPUT) + message(FATAL_ERROR "generate_out: Missing OUTPUT argument") + endif() + + add_custom_command(OUTPUT "${_GO_OUTPUT}" + COMMAND "${CMAKE_COMMAND}" + "-DINPUT=${_GO_INPUT}" + "-DOUTPUT=${_GO_OUTPUT}" + -P "${CMAKE_CURRENT_BINARY_DIR}/scripts/genout.cmake" + DEPENDS "${_GO_INPUT}" ${_GO_DEPENDS} + WORKING_DIRECTORY "${CMAKE_CURRENT_BINARY_DIR}") + endfunction() + + # Generate specific source file with awk + # generate_source(OUTPUT outputfile [DEPENDS dep1 [dep2...]]) + function(generate_source) + set(options) + set(oneValueArgs OUTPUT) + set(multiValueArgs DEPENDS) + cmake_parse_arguments(_GSO "${options}" "${oneValueArgs}" "${multiValueArgs}" ${ARGN}) + if(NOT _GSO_OUTPUT) + message(FATAL_ERROR "generate_source: Missing OUTPUT argument") + endif() + + add_custom_command(OUTPUT "${CMAKE_CURRENT_BINARY_DIR}/${_GSO_OUTPUT}" + COMMAND "${CMAKE_COMMAND}" + "-DOUTPUT=${_GSO_OUTPUT}" + -P "${CMAKE_CURRENT_BINARY_DIR}/scripts/gensrc.cmake" + DEPENDS ${_GSO_DEPENDS} + WORKING_DIRECTORY "${CMAKE_CURRENT_BINARY_DIR}") + endfunction() + + # Copy file + function(generate_copy source destination) + add_custom_command(OUTPUT "${destination}" + COMMAND "${CMAKE_COMMAND}" -E remove "${destination}" + COMMAND "${CMAKE_COMMAND}" -E copy "${source}" + "${destination}" + DEPENDS "${source}") + endfunction() + + # Generate scripts/pnglibconf.h + generate_source(OUTPUT "scripts/pnglibconf.c" + DEPENDS "${CMAKE_CURRENT_SOURCE_DIR}/scripts/pnglibconf.dfa" + "${CMAKE_CURRENT_SOURCE_DIR}/scripts/options.awk" + "${CMAKE_CURRENT_SOURCE_DIR}/pngconf.h") + + # Generate pnglibconf.c + generate_source(OUTPUT "pnglibconf.c" + DEPENDS "${CMAKE_CURRENT_SOURCE_DIR}/scripts/pnglibconf.dfa" + "${CMAKE_CURRENT_SOURCE_DIR}/scripts/options.awk" + "${CMAKE_CURRENT_SOURCE_DIR}/pngconf.h") + + if(PNG_PREFIX) + set(PNGLIBCONF_H_EXTRA_DEPENDS + "${CMAKE_CURRENT_BINARY_DIR}/scripts/prefix.out" + "${CMAKE_CURRENT_SOURCE_DIR}/scripts/macro.lst") + set(PNGPREFIX_H_EXTRA_DEPENDS + "${CMAKE_CURRENT_BINARY_DIR}/scripts/intprefix.out") + endif() + + generate_out(INPUT "${CMAKE_CURRENT_BINARY_DIR}/pnglibconf.c" + OUTPUT "${CMAKE_CURRENT_BINARY_DIR}/pnglibconf.out") + + # Generate pnglibconf.h + generate_source(OUTPUT "pnglibconf.h" + DEPENDS "${CMAKE_CURRENT_BINARY_DIR}/pnglibconf.out" + ${PNGLIBCONF_H_EXTRA_DEPENDS}) + + generate_out(INPUT "${CMAKE_CURRENT_SOURCE_DIR}/scripts/intprefix.c" + OUTPUT "${CMAKE_CURRENT_BINARY_DIR}/scripts/intprefix.out" + DEPENDS "${CMAKE_CURRENT_BINARY_DIR}/pnglibconf.h") + + generate_out(INPUT "${CMAKE_CURRENT_SOURCE_DIR}/scripts/prefix.c" + OUTPUT "${CMAKE_CURRENT_BINARY_DIR}/scripts/prefix.out" + DEPENDS "${CMAKE_CURRENT_SOURCE_DIR}/png.h" + "${CMAKE_CURRENT_SOURCE_DIR}/pngconf.h" + "${CMAKE_CURRENT_BINARY_DIR}/pnglibconf.out") + + # Generate pngprefix.h + generate_source(OUTPUT "pngprefix.h" + DEPENDS ${PNGPREFIX_H_EXTRA_DEPENDS}) + + generate_out(INPUT "${CMAKE_CURRENT_SOURCE_DIR}/scripts/sym.c" + OUTPUT "${CMAKE_CURRENT_BINARY_DIR}/scripts/sym.out" + DEPENDS "${CMAKE_CURRENT_BINARY_DIR}/pnglibconf.h") + + generate_out(INPUT "${CMAKE_CURRENT_SOURCE_DIR}/scripts/symbols.c" + OUTPUT "${CMAKE_CURRENT_BINARY_DIR}/scripts/symbols.out" + DEPENDS "${CMAKE_CURRENT_SOURCE_DIR}/png.h" + "${CMAKE_CURRENT_SOURCE_DIR}/pngconf.h" + "${CMAKE_CURRENT_SOURCE_DIR}/scripts/pnglibconf.h.prebuilt") + + generate_out(INPUT "${CMAKE_CURRENT_SOURCE_DIR}/scripts/vers.c" + OUTPUT "${CMAKE_CURRENT_BINARY_DIR}/scripts/vers.out" + DEPENDS "${CMAKE_CURRENT_SOURCE_DIR}/png.h" + "${CMAKE_CURRENT_SOURCE_DIR}/pngconf.h" + "${CMAKE_CURRENT_BINARY_DIR}/pnglibconf.h") + + generate_chk(INPUT "${CMAKE_CURRENT_BINARY_DIR}/scripts/symbols.out" + OUTPUT "${CMAKE_CURRENT_BINARY_DIR}/scripts/symbols.chk" + DEPENDS "${CMAKE_CURRENT_SOURCE_DIR}/scripts/checksym.awk" + "${CMAKE_CURRENT_SOURCE_DIR}/scripts/symbols.def") + + add_custom_target(symbol-check DEPENDS + "${CMAKE_CURRENT_BINARY_DIR}/scripts/symbols.chk") + + generate_copy("${CMAKE_CURRENT_BINARY_DIR}/scripts/sym.out" + "${CMAKE_CURRENT_BINARY_DIR}/libpng.sym") + generate_copy("${CMAKE_CURRENT_BINARY_DIR}/scripts/vers.out" + "${CMAKE_CURRENT_BINARY_DIR}/libpng.vers") + + add_custom_target(genvers DEPENDS "${CMAKE_CURRENT_BINARY_DIR}/libpng.vers") + add_custom_target(gensym DEPENDS "${CMAKE_CURRENT_BINARY_DIR}/libpng.sym") + + add_custom_target("genprebuilt" + COMMAND "${CMAKE_COMMAND}" + "-DOUTPUT=scripts/pnglibconf.h.prebuilt" + -P "${CMAKE_CURRENT_BINARY_DIR}/scripts/gensrc.cmake" + WORKING_DIRECTORY "${CMAKE_CURRENT_BINARY_DIR}") + + # A single target handles generation of all generated files. If + # they are depended upon separately by multiple targets, this + # confuses parallel make (it would require a separate top-level + # target for each file to track the dependencies properly). + add_custom_target(genfiles DEPENDS + "${CMAKE_CURRENT_BINARY_DIR}/libpng.sym" + "${CMAKE_CURRENT_BINARY_DIR}/libpng.vers" + "${CMAKE_CURRENT_BINARY_DIR}/pnglibconf.c" + "${CMAKE_CURRENT_BINARY_DIR}/pnglibconf.h" + "${CMAKE_CURRENT_BINARY_DIR}/pnglibconf.out" + "${CMAKE_CURRENT_BINARY_DIR}/pngprefix.h" + "${CMAKE_CURRENT_BINARY_DIR}/scripts/intprefix.out" + "${CMAKE_CURRENT_BINARY_DIR}/scripts/pnglibconf.c" + "${CMAKE_CURRENT_BINARY_DIR}/scripts/prefix.out" + "${CMAKE_CURRENT_BINARY_DIR}/scripts/sym.out" + "${CMAKE_CURRENT_BINARY_DIR}/scripts/symbols.chk" + "${CMAKE_CURRENT_BINARY_DIR}/scripts/symbols.out" + "${CMAKE_CURRENT_BINARY_DIR}/scripts/vers.out") +endif(NOT AWK OR ANDROID) + +# OUR SOURCES +set(libpng_public_hdrs + png.h + pngconf.h + "${CMAKE_CURRENT_BINARY_DIR}/pnglibconf.h" +) +set(libpng_private_hdrs + pngpriv.h + pngdebug.h + pnginfo.h + pngstruct.h +) +if(AWK AND NOT ANDROID) + list(APPEND libpng_private_hdrs "${CMAKE_CURRENT_BINARY_DIR}/pngprefix.h") +endif() +set(libpng_sources + ${libpng_public_hdrs} + ${libpng_private_hdrs} + png.c + pngerror.c + pngget.c + pngmem.c + pngpread.c + pngread.c + pngrio.c + pngrtran.c + pngrutil.c + pngset.c + pngtrans.c + pngwio.c + pngwrite.c + pngwtran.c + pngwutil.c + ${libpng_arm_sources} + ${libpng_intel_sources} + ${libpng_mips_sources} + ${libpng_powerpc_sources} +) +set(pngtest_sources + pngtest.c +) +set(pngvalid_sources + contrib/libtests/pngvalid.c +) +set(pngstest_sources + contrib/libtests/pngstest.c +) +set(pngunknown_sources + contrib/libtests/pngunknown.c +) +set(pngimage_sources + contrib/libtests/pngimage.c +) +set(pngfix_sources + contrib/tools/pngfix.c +) +set(png_fix_itxt_sources + contrib/tools/png-fix-itxt.c +) + +if(MSVC) + add_definitions(-D_CRT_SECURE_NO_DEPRECATE) +endif() + +if(PNG_DEBUG) + add_definitions(-DPNG_DEBUG) +endif() + +# NOW BUILD OUR TARGET +include_directories(${CMAKE_CURRENT_SOURCE_DIR} ${ZLIB_INCLUDE_DIR}) + +unset(PNG_LIB_TARGETS) + +if(PNG_STATIC) + # does not work without changing name + set(PNG_LIB_NAME_STATIC png_static) + add_library(png_static STATIC ${libpng_sources}) + add_dependencies(png_static genfiles) + # MSVC doesn't use a different file extension for shared vs. static + # libs. We are able to change OUTPUT_NAME to remove the _static + # for all other platforms. + if(NOT MSVC) + set_target_properties(png_static PROPERTIES + OUTPUT_NAME "${PNG_LIB_NAME}" + CLEAN_DIRECT_OUTPUT 1) + else() + set_target_properties(png_static PROPERTIES + OUTPUT_NAME "${PNG_LIB_NAME}_static" + CLEAN_DIRECT_OUTPUT 1) + endif() + list(APPEND PNG_LIB_TARGETS png_static) + if(MSVC) + # msvc does not append 'lib' - do it here to have consistent name + set_target_properties(png_static PROPERTIES PREFIX "lib") + endif() + target_link_libraries(png_static ${M_LIBRARY}) +endif() + +if(NOT PNG_LIB_TARGETS) + message(SEND_ERROR + "No library variant selected to build. " + "Please enable at least one of the following options: " + "PNG_STATIC, PNG_SHARED, PNG_FRAMEWORK") +endif() + +# Set a variable with CMake code which: +# Creates a symlink from src to dest (if possible) or alternatively +# copies if different. +include(CMakeParseArguments) + +function(create_symlink DEST_FILE) + + cmake_parse_arguments(S "" "FILE;TARGET" "" ${ARGN}) + + if(NOT S_TARGET AND NOT S_FILE) + message(FATAL_ERROR "create_symlink: Missing TARGET or FILE argument") + endif() + + if(S_TARGET AND S_FILE) + message(FATAL_ERROR "create_symlink: Both source file ${S_FILE} and build target ${S_TARGET} arguments are present; can only have one.") + endif() + + if(S_FILE) + # If we don't need to symlink something that's coming from a build target, + # we can go ahead and symlink/copy at configure time. + if(CMAKE_HOST_WIN32 AND NOT CYGWIN) + execute_process( + COMMAND "${CMAKE_COMMAND}" -E copy_if_different ${S_FILE} ${DEST_FILE} + WORKING_DIRECTORY "${CMAKE_CURRENT_BINARY_DIR}") + else() + execute_process( + COMMAND ${CMAKE_COMMAND} -E create_symlink ${S_FILE} ${DEST_FILE} + WORKING_DIRECTORY "${CMAKE_CURRENT_BINARY_DIR}") + endif() + endif() + + if(S_TARGET) + # We need to use generator expressions, which can be a bit tricky, so for + # simplicity make the symlink a POST_BUILD step and use the TARGET + # signature of add_custom_command. + if(CMAKE_HOST_WIN32 AND NOT CYGWIN) + add_custom_command(TARGET ${S_TARGET} POST_BUILD + COMMAND "${CMAKE_COMMAND}" -E copy_if_different $ $/${DEST_FILE}) + else() + add_custom_command(TARGET ${S_TARGET} POST_BUILD + COMMAND "${CMAKE_COMMAND}" -E create_symlink $ $/${DEST_FILE}) + endif() + endif() + +endfunction() + +# Create source generation scripts. +configure_file(${CMAKE_CURRENT_SOURCE_DIR}/scripts/genchk.cmake.in + ${CMAKE_CURRENT_BINARY_DIR}/scripts/genchk.cmake @ONLY) +configure_file(${CMAKE_CURRENT_SOURCE_DIR}/scripts/genout.cmake.in + ${CMAKE_CURRENT_BINARY_DIR}/scripts/genout.cmake @ONLY) +configure_file(${CMAKE_CURRENT_SOURCE_DIR}/scripts/gensrc.cmake.in + ${CMAKE_CURRENT_BINARY_DIR}/scripts/gensrc.cmake @ONLY) + +# libpng is a library so default to 'lib' +if(NOT DEFINED CMAKE_INSTALL_LIBDIR) + set(CMAKE_INSTALL_LIBDIR lib) +endif() + +# CREATE PKGCONFIG FILES +# We use the same files like ./configure, so we have to set its vars. +# Only do this on Windows for Cygwin - the files don't make much sense outside +# of a UNIX look-alike. +if(NOT WIN32 OR CYGWIN OR MINGW) + set(prefix ${CMAKE_INSTALL_PREFIX}) + set(exec_prefix ${CMAKE_INSTALL_PREFIX}) + set(libdir ${CMAKE_INSTALL_FULL_LIBDIR}) + set(includedir ${CMAKE_INSTALL_FULL_INCLUDEDIR}) + set(LIBS "-lz -lm") + configure_file(${CMAKE_CURRENT_SOURCE_DIR}/libpng.pc.in + ${CMAKE_CURRENT_BINARY_DIR}/${PNGLIB_NAME}.pc @ONLY) + create_symlink(libpng.pc FILE ${PNGLIB_NAME}.pc) + + configure_file(${CMAKE_CURRENT_SOURCE_DIR}/libpng-config.in + ${CMAKE_CURRENT_BINARY_DIR}/${PNGLIB_NAME}-config @ONLY) + create_symlink(libpng-config FILE ${PNGLIB_NAME}-config) +endif() + +# SET UP LINKS +if(PNG_SHARED) + set_target_properties(png PROPERTIES +# VERSION 16.${PNGLIB_RELEASE}.1.6.37 + VERSION 16.${PNGLIB_RELEASE}.0 + SOVERSION 16 + CLEAN_DIRECT_OUTPUT 1) +endif() + +# INSTALL +if(NOT SKIP_INSTALL_LIBRARIES AND NOT SKIP_INSTALL_ALL) + install(TARGETS ${PNG_LIB_TARGETS} + EXPORT libpng + RUNTIME DESTINATION bin + LIBRARY DESTINATION ${CMAKE_INSTALL_LIBDIR} + ARCHIVE DESTINATION ${CMAKE_INSTALL_LIBDIR} + FRAMEWORK DESTINATION ${CMAKE_INSTALL_LIBDIR}) + + if(PNG_SHARED) + # Create a symlink for libpng.dll.a => libpng16.dll.a on Cygwin + if(CYGWIN OR MINGW) + create_symlink(libpng${CMAKE_IMPORT_LIBRARY_SUFFIX} TARGET png) + install(FILES $/libpng${CMAKE_IMPORT_LIBRARY_SUFFIX} + DESTINATION ${CMAKE_INSTALL_LIBDIR}) + endif() + + if(NOT WIN32) + create_symlink(libpng${CMAKE_SHARED_LIBRARY_SUFFIX} TARGET png) + install(FILES $/libpng${CMAKE_SHARED_LIBRARY_SUFFIX} + DESTINATION ${CMAKE_INSTALL_LIBDIR}) + endif() + endif() + + if(PNG_STATIC) + if(NOT WIN32 OR CYGWIN OR MINGW) + create_symlink(libpng${CMAKE_STATIC_LIBRARY_SUFFIX} TARGET png_static) + install(FILES $/libpng${CMAKE_STATIC_LIBRARY_SUFFIX} + DESTINATION ${CMAKE_INSTALL_LIBDIR}) + endif() + endif() +endif() + +if(NOT SKIP_INSTALL_HEADERS AND NOT SKIP_INSTALL_ALL) + install(FILES ${libpng_public_hdrs} DESTINATION include) + install(FILES ${libpng_public_hdrs} DESTINATION include/${PNGLIB_NAME}) +endif() +if(NOT SKIP_INSTALL_EXECUTABLES AND NOT SKIP_INSTALL_ALL) + if(NOT WIN32 OR CYGWIN OR MINGW) + install(PROGRAMS ${CMAKE_CURRENT_BINARY_DIR}/libpng-config DESTINATION bin) + install(PROGRAMS ${CMAKE_CURRENT_BINARY_DIR}/${PNGLIB_NAME}-config DESTINATION bin) + endif() +endif() + +if(NOT SKIP_INSTALL_PROGRAMS AND NOT SKIP_INSTALL_ALL) + install(TARGETS ${PNG_BIN_TARGETS} + RUNTIME DESTINATION bin) +endif() + +if(NOT SKIP_INSTALL_FILES AND NOT SKIP_INSTALL_ALL) + # Install man pages + if(NOT PNG_MAN_DIR) + set(PNG_MAN_DIR "share/man") + endif() + install(FILES libpng.3 libpngpf.3 DESTINATION ${PNG_MAN_DIR}/man3) + install(FILES png.5 DESTINATION ${PNG_MAN_DIR}/man5) + # Install pkg-config files + if(NOT CMAKE_HOST_WIN32 OR CYGWIN OR MINGW) + install(FILES ${CMAKE_CURRENT_BINARY_DIR}/libpng.pc + DESTINATION ${CMAKE_INSTALL_LIBDIR}/pkgconfig) + install(PROGRAMS ${CMAKE_CURRENT_BINARY_DIR}/libpng-config + DESTINATION bin) + install(FILES ${CMAKE_CURRENT_BINARY_DIR}/${PNGLIB_NAME}.pc + DESTINATION ${CMAKE_INSTALL_LIBDIR}/pkgconfig) + install(PROGRAMS ${CMAKE_CURRENT_BINARY_DIR}/${PNGLIB_NAME}-config + DESTINATION bin) + endif() +endif() + +# Create an export file that CMake users can include() to import our targets. +if(NOT SKIP_INSTALL_EXPORT AND NOT SKIP_INSTALL_ALL) + install(EXPORT libpng DESTINATION lib/libpng FILE lib${PNG_LIB_NAME}.cmake) +endif() + +# what's with libpng-manual.txt and all the extra files? + +# UNINSTALL +# do we need this? + +# DIST +# do we need this? + +# to create msvc import lib for mingw compiled shared lib +# pexports libpng.dll > libpng.def +# lib /def:libpng.def /machine:x86 diff --git a/cmake/CMakeLists.txt b/cmake/CMakeLists.txt index 82280e3ce9..ff187c6366 100644 --- a/cmake/CMakeLists.txt +++ b/cmake/CMakeLists.txt @@ -446,14 +446,43 @@ endif() find_package(PNG QUIET) find_package(ZLIB QUIET) +if((NOT ZLIB_FOUND) AND (CMAKE_VERSION VERSION_GREATER_EQUAL 3.16)) + set(LIBZ_URL http://prdownloads.sourceforge.net/libpng/zlib-1.2.11.tar.gz) + set(LIBZ_MD5 1c9f62f0778697a09d36121ead88e08e) + mark_as_advanced(LIBZ_URL) + mark_as_advanced(LIBZ_MD5) + include(ExternalCMakeProject) + ExternalCmakeProject(libz ${LIBZ_URL} ${LIBZ_MD5} zlib . CMakeLists.zlib) + add_library(ZLIB::ZLIB ALIAS zlibstatic) + target_include_directories(lammps PRIVATE "${CMAKE_BINARY_DIR}/_deps/libz-src") + target_include_directories(lammps PRIVATE "${CMAKE_BINARY_DIR}/_deps/libz-build") + set(ZLIB_FOUND TRUE) + set(ZLIB_INCLUDE_DIR "${CMAKE_BINARY_DIR}/_deps/libz-src;${CMAKE_BINARY_DIR}/_deps/libz-build") +endif() +if((NOT PNG_FOUND) AND (CMAKE_VERSION VERSION_GREATER_EQUAL 3.16)) + set(LIBPNG_URL http://prdownloads.sourceforge.net/libpng/libpng-1.6.37.tar.gz) + set(LIBPNG_MD5 6c7519f6c75939efa0ed3053197abd54) + mark_as_advanced(LIBPNG_URL) + mark_as_advanced(LIBPNG_MD5) + include(ExternalCMakeProject) + ExternalCmakeProject(libpng ${LIBPNG_URL} ${LIBPNG_MD5} libpng . CMakeLists.png) + add_library(PNG::PNG ALIAS png_static) + target_include_directories(lammps PRIVATE "${CMAKE_BINARY_DIR}/_deps/libpng-src") + target_include_directories(lammps PRIVATE "${CMAKE_BINARY_DIR}/_deps/libpng-build") + set(PNG_FOUND TRUE) +endif() if(PNG_FOUND AND ZLIB_FOUND) option(WITH_PNG "Enable PNG support" ON) else() option(WITH_PNG "Enable PNG support" OFF) endif() if(WITH_PNG) - find_package(PNG REQUIRED) - find_package(ZLIB REQUIRED) + if(NOT PNG_FOUND) + find_package(PNG REQUIRED) + endif() + if(NOT ZLIB_FOUND) + find_package(ZLIB REQUIRED) + endif() target_link_libraries(lammps PRIVATE PNG::PNG ZLIB::ZLIB) target_compile_definitions(lammps PRIVATE -DLAMMPS_PNG) endif() diff --git a/cmake/CMakeLists.zlib b/cmake/CMakeLists.zlib new file mode 100644 index 0000000000..a33f14ce64 --- /dev/null +++ b/cmake/CMakeLists.zlib @@ -0,0 +1,195 @@ +cmake_minimum_required(VERSION 3.10) +# When using CMake 3.4 and later, don't export symbols from executables unless +# the CMAKE_ENABLE_EXPORTS variable is set. +if(POLICY CMP0065) + cmake_policy(SET CMP0065 NEW) +endif() +if (POLICY CMP0077) + cmake_policy(SET CMP0077 NEW) +endif() +set(CMAKE_ALLOW_LOOSE_LOOP_CONSTRUCTS ON) + +project(zlib C) + +set(VERSION "1.2.11") + +option(ASM686 "Enable building i686 assembly implementation" OFF) +option(AMD64 "Enable building amd64 assembly implementation" OFF) + +set(INSTALL_BIN_DIR "${CMAKE_INSTALL_PREFIX}/bin" CACHE PATH "Installation directory for executables") +set(INSTALL_LIB_DIR "${CMAKE_INSTALL_PREFIX}/lib" CACHE PATH "Installation directory for libraries") +set(INSTALL_INC_DIR "${CMAKE_INSTALL_PREFIX}/include" CACHE PATH "Installation directory for headers") +set(INSTALL_MAN_DIR "${CMAKE_INSTALL_PREFIX}/share/man" CACHE PATH "Installation directory for manual pages") +set(INSTALL_PKGCONFIG_DIR "${CMAKE_INSTALL_PREFIX}/share/pkgconfig" CACHE PATH "Installation directory for pkgconfig (.pc) files") + +include(CheckTypeSize) +include(CheckFunctionExists) +include(CheckIncludeFile) +include(CheckCSourceCompiles) + +check_include_file(sys/types.h HAVE_SYS_TYPES_H) +check_include_file(stdint.h HAVE_STDINT_H) +check_include_file(stddef.h HAVE_STDDEF_H) + +# +# Check to see if we have large file support +# +set(CMAKE_REQUIRED_DEFINITIONS -D_LARGEFILE64_SOURCE=1) +# We add these other definitions here because CheckTypeSize.cmake +# in CMake 2.4.x does not automatically do so and we want +# compatibility with CMake 2.4.x. +if(HAVE_SYS_TYPES_H) + list(APPEND CMAKE_REQUIRED_DEFINITIONS -DHAVE_SYS_TYPES_H) +endif() +if(HAVE_STDINT_H) + list(APPEND CMAKE_REQUIRED_DEFINITIONS -DHAVE_STDINT_H) +endif() +if(HAVE_STDDEF_H) + list(APPEND CMAKE_REQUIRED_DEFINITIONS -DHAVE_STDDEF_H) +endif() +check_type_size(off64_t OFF64_T) +check_type_size(off64_t OFF64_T) +if(HAVE_OFF64_T) + add_definitions(-D_LARGEFILE64_SOURCE=1) +endif() +set(CMAKE_REQUIRED_DEFINITIONS) # clear variable + +# +# Check for fseeko +# +check_function_exists(fseeko HAVE_FSEEKO) +if(NOT HAVE_FSEEKO) + add_definitions(-DNO_FSEEKO) +endif() + +# +# Check for unistd.h +# +check_include_file(unistd.h Z_HAVE_UNISTD_H) + +if(MSVC) + set(CMAKE_DEBUG_POSTFIX "d") + add_definitions(-D_CRT_SECURE_NO_DEPRECATE) + add_definitions(-D_CRT_NONSTDC_NO_DEPRECATE) + include_directories(${CMAKE_CURRENT_SOURCE_DIR}) +endif() + +if(NOT CMAKE_CURRENT_SOURCE_DIR STREQUAL CMAKE_CURRENT_BINARY_DIR) + # If we're doing an out of source build and the user has a zconf.h + # in their source tree... + if(EXISTS ${CMAKE_CURRENT_SOURCE_DIR}/zconf.h) + file(RENAME ${CMAKE_CURRENT_SOURCE_DIR}/zconf.h ${CMAKE_CURRENT_SOURCE_DIR}/zconf.h.included) + endif() +endif() + +set(ZLIB_PC ${CMAKE_CURRENT_BINARY_DIR}/zlib.pc) +configure_file( ${CMAKE_CURRENT_SOURCE_DIR}/zlib.pc.cmakein + ${ZLIB_PC} @ONLY) +configure_file( ${CMAKE_CURRENT_SOURCE_DIR}/zconf.h.cmakein + ${CMAKE_CURRENT_BINARY_DIR}/zconf.h @ONLY) +include_directories(${CMAKE_CURRENT_BINARY_DIR} ${CMAKE_SOURCE_DIR}) + + +#============================================================================ +# zlib +#============================================================================ + +set(ZLIB_PUBLIC_HDRS + ${CMAKE_CURRENT_BINARY_DIR}/zconf.h + zlib.h +) +set(ZLIB_PRIVATE_HDRS + crc32.h + deflate.h + gzguts.h + inffast.h + inffixed.h + inflate.h + inftrees.h + trees.h + zutil.h +) +set(ZLIB_SRCS + adler32.c + compress.c + crc32.c + deflate.c + gzclose.c + gzlib.c + gzread.c + gzwrite.c + inflate.c + infback.c + inftrees.c + inffast.c + trees.c + uncompr.c + zutil.c +) + +if(NOT MINGW) + set(ZLIB_DLL_SRCS + win32/zlib1.rc # If present will override custom build rule below. + ) +endif() + +if(CMAKE_COMPILER_IS_GNUCC) + if(ASM686) + set(ZLIB_ASMS contrib/asm686/match.S) + elseif (AMD64) + set(ZLIB_ASMS contrib/amd64/amd64-match.S) + endif () + + if(ZLIB_ASMS) + add_definitions(-DASMV) + set_source_files_properties(${ZLIB_ASMS} PROPERTIES LANGUAGE C COMPILE_FLAGS -DNO_UNDERLINE) + endif() +endif() + +if(MSVC) + if(ASM686) + ENABLE_LANGUAGE(ASM_MASM) + set(ZLIB_ASMS + contrib/masmx86/inffas32.asm + contrib/masmx86/match686.asm + ) + elseif (AMD64) + ENABLE_LANGUAGE(ASM_MASM) + set(ZLIB_ASMS + contrib/masmx64/gvmat64.asm + contrib/masmx64/inffasx64.asm + ) + endif() + + if(ZLIB_ASMS) + add_definitions(-DASMV -DASMINF) + endif() +endif() + +# parse the full version number from zlib.h and include in ZLIB_FULL_VERSION +file(READ ${CMAKE_CURRENT_SOURCE_DIR}/zlib.h _zlib_h_contents) +string(REGEX REPLACE ".*#define[ \t]+ZLIB_VERSION[ \t]+\"([-0-9A-Za-z.]+)\".*" + "\\1" ZLIB_FULL_VERSION ${_zlib_h_contents}) + +if(MINGW) + # This gets us DLL resource information when compiling on MinGW. + if(NOT CMAKE_RC_COMPILER) + set(CMAKE_RC_COMPILER windres.exe) + endif() + + add_custom_command(OUTPUT ${CMAKE_CURRENT_BINARY_DIR}/zlib1rc.obj + COMMAND ${CMAKE_RC_COMPILER} + -D GCC_WINDRES + -I ${CMAKE_CURRENT_SOURCE_DIR} + -I ${CMAKE_CURRENT_BINARY_DIR} + -o ${CMAKE_CURRENT_BINARY_DIR}/zlib1rc.obj + -i ${CMAKE_CURRENT_SOURCE_DIR}/win32/zlib1.rc) + set(ZLIB_DLL_SRCS ${CMAKE_CURRENT_BINARY_DIR}/zlib1rc.obj) +endif(MINGW) + +add_library(zlibstatic STATIC ${ZLIB_SRCS} ${ZLIB_ASMS} ${ZLIB_PUBLIC_HDRS} ${ZLIB_PRIVATE_HDRS}) + +if(UNIX) + # On unix-like platforms the library is almost always called libz + set_target_properties(zlibstatic PROPERTIES OUTPUT_NAME z) +endif() \ No newline at end of file diff --git a/cmake/Modules/Packages/COMPRESS.cmake b/cmake/Modules/Packages/COMPRESS.cmake index bdcf1aa3f8..599f1d0079 100644 --- a/cmake/Modules/Packages/COMPRESS.cmake +++ b/cmake/Modules/Packages/COMPRESS.cmake @@ -1,4 +1,6 @@ -find_package(ZLIB REQUIRED) +if(NOT ZLIB_FOUND) + find_package(ZLIB REQUIRED) +endif() target_link_libraries(lammps PRIVATE ZLIB::ZLIB) find_package(PkgConfig QUIET) @@ -8,4 +10,4 @@ if(PkgConfig_FOUND) target_compile_definitions(lammps PRIVATE -DLAMMPS_ZSTD) target_link_libraries(lammps PRIVATE PkgConfig::Zstd) endif() -endif() +endif() \ No newline at end of file From d905d3fbf5bfd4fa9f48240bc13b589e726ca70e Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sun, 22 May 2022 17:46:12 -0400 Subject: [PATCH 192/585] reorganize build settings and presets --- cmake/CMakeSettings.json | 94 ++++++++++++------------------------- cmake/presets/windows.cmake | 2 + 2 files changed, 33 insertions(+), 63 deletions(-) diff --git a/cmake/CMakeSettings.json b/cmake/CMakeSettings.json index b0f940277f..6d4894f5c2 100644 --- a/cmake/CMakeSettings.json +++ b/cmake/CMakeSettings.json @@ -8,7 +8,7 @@ "installRoot": "${workspaceRoot}\\install\\${name}", "cmakeCommandArgs": "-C ${workspaceRoot}\\cmake\\presets\\windows.cmake", "buildCommandArgs": "", - "ctestCommandArgs": "", + "ctestCommandArgs": "-V", "inheritEnvironments": [ "msvc_x64_x64" ], "variables": [ { @@ -26,11 +26,6 @@ "value": "True", "type": "BOOL" }, - { - "name": "PKG_PYTHON", - "value": "True", - "type": "BOOL" - }, { "name": "ENABLE_TESTING", "value": "True", @@ -46,7 +41,7 @@ "installRoot": "${workspaceRoot}\\install\\${name}", "cmakeCommandArgs": "-C ${workspaceRoot}\\cmake\\presets\\windows.cmake", "buildCommandArgs": "", - "ctestCommandArgs": "", + "ctestCommandArgs": "-V", "inheritEnvironments": [ "msvc_x64_x64" ], "variables": [ { @@ -64,11 +59,6 @@ "value": "True", "type": "BOOL" }, - { - "name": "PKG_PYTHON", - "value": "True", - "type": "BOOL" - }, { "name": "ENABLE_TESTING", "value": "True", @@ -102,11 +92,6 @@ "value": "True", "type": "BOOL" }, - { - "name": "PKG_PYTHON", - "value": "True", - "type": "BOOL" - }, { "name": "ENABLE_TESTING", "value": "True", @@ -122,7 +107,7 @@ "installRoot": "${workspaceRoot}\\install\\${name}", "cmakeCommandArgs": "-C ${workspaceRoot}\\cmake\\presets\\windows.cmake -DCMAKE_C_COMPILER=clang-cl.exe -DCMAKE_CXX_COMPILER=clang-cl.exe", "buildCommandArgs": "", - "ctestCommandArgs": "", + "ctestCommandArgs": "-V", "inheritEnvironments": [ "clang_cl_x64" ], "variables": [ { @@ -140,11 +125,6 @@ "value": "True", "type": "BOOL" }, - { - "name": "PKG_PYTHON", - "value": "True", - "type": "BOOL" - }, { "name": "ENABLE_TESTING", "value": "True", @@ -158,9 +138,16 @@ "configurationType": "Debug", "buildRoot": "${workspaceRoot}\\build\\${name}", "installRoot": "${workspaceRoot}\\install\\${name}", + "buildCommandArgs": "", + "ctestCommandArgs": "-V", "inheritEnvironments": [], "cmakeCommandArgs": "-C ${workspaceRoot}\\cmake\\presets\\windows-intel-llvm.cmake -C ${workspaceRoot}\\cmake\\presets\\windows.cmake", "variables": [ + { + "name": "PKG_ELECTRON", + "value": "True", + "type": "BOOL" + }, { "name": "BUILD_SHARED_LIBS", "value": "True", @@ -176,11 +163,6 @@ "value": "True", "type": "BOOL" }, - { - "name": "PKG_PYTHON", - "value": "True", - "type": "BOOL" - }, { "name": "ENABLE_TESTING", "value": "True", @@ -190,11 +172,6 @@ "name": "FFT", "value": "MKL", "type": "STRING" - }, - { - "name": "PKG_PLUGIN", - "value": "True", - "type": "BOOL" } ] }, @@ -205,8 +182,15 @@ "buildRoot": "${workspaceRoot}\\build\\${name}", "installRoot": "${workspaceRoot}\\install\\${name}", "cmakeCommandArgs": "-C ${workspaceRoot}\\cmake\\presets\\windows-intel-llvm.cmake -C ${workspaceRoot}\\cmake\\presets\\windows.cmake", + "buildCommandArgs": "", + "ctestCommandArgs": "-V", "inheritEnvironments": [], "variables": [ + { + "name": "PKG_ELECTRON", + "value": "True", + "type": "BOOL" + }, { "name": "BUILD_SHARED_LIBS", "value": "True", @@ -222,11 +206,6 @@ "value": "True", "type": "BOOL" }, - { - "name": "PKG_PYTHON", - "value": "True", - "type": "BOOL" - }, { "name": "ENABLE_TESTING", "value": "True", @@ -236,11 +215,6 @@ "name": "FFT", "value": "MKL", "type": "STRING" - }, - { - "name": "PKG_PLUGIN", - "value": "True", - "type": "BOOL" } ] }, @@ -251,8 +225,15 @@ "buildRoot": "${workspaceRoot}\\build\\${name}", "installRoot": "${workspaceRoot}\\install\\${name}", "cmakeCommandArgs": "-C ${workspaceRoot}\\cmake\\presets\\windows-intel-classic.cmake -C ${workspaceRoot}\\cmake\\presets\\windows.cmake", + "buildCommandArgs": "", + "ctestCommandArgs": "-V", "inheritEnvironments": [], "variables": [ + { + "name": "PKG_ELECTRON", + "value": "True", + "type": "BOOL" + }, { "name": "BUILD_SHARED_LIBS", "value": "True", @@ -268,11 +249,6 @@ "value": "True", "type": "BOOL" }, - { - "name": "PKG_PYTHON", - "value": "True", - "type": "BOOL" - }, { "name": "ENABLE_TESTING", "value": "False", @@ -282,11 +258,6 @@ "name": "FFT", "value": "MKL", "type": "STRING" - }, - { - "name": "PKG_PLUGIN", - "value": "True", - "type": "BOOL" } ] }, @@ -297,8 +268,15 @@ "buildRoot": "${workspaceRoot}\\build\\${name}", "installRoot": "${workspaceRoot}\\install\\${name}", "cmakeCommandArgs": "-C ${workspaceRoot}\\cmake\\presets\\windows-intel-classic.cmake -C ${workspaceRoot}\\cmake\\presets\\windows.cmake", + "buildCommandArgs": "", + "ctestCommandArgs": "-V", "inheritEnvironments": [], "variables": [ + { + "name": "PKG_ELECTRON", + "value": "True", + "type": "BOOL" + }, { "name": "BUILD_SHARED_LIBS", "value": "True", @@ -314,11 +292,6 @@ "value": "True", "type": "BOOL" }, - { - "name": "PKG_PYTHON", - "value": "True", - "type": "BOOL" - }, { "name": "ENABLE_TESTING", "value": "False", @@ -328,11 +301,6 @@ "name": "FFT", "value": "MKL", "type": "STRING" - }, - { - "name": "PKG_PLUGIN", - "value": "True", - "type": "BOOL" } ] } diff --git a/cmake/presets/windows.cmake b/cmake/presets/windows.cmake index c83b16d855..5a3ac217f1 100644 --- a/cmake/presets/windows.cmake +++ b/cmake/presets/windows.cmake @@ -9,6 +9,7 @@ set(WIN_PACKAGES CLASS2 COLLOID COLVARS + COMPRESS CORESHELL DIELECTRIC DIFFRACTION @@ -43,6 +44,7 @@ set(WIN_PACKAGES PERI PHONON POEMS + PLUGIN PTM QEQ QTB From 46df8abe756d6f7ac5a3ef220eb0ddd5a23d98fa Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sun, 22 May 2022 17:49:54 -0400 Subject: [PATCH 193/585] rename jpeg cmake file for consistency --- cmake/{CMakeLists.libjpeg => CMakeLists.jpeg} | 0 cmake/CMakeLists.txt | 2 +- 2 files changed, 1 insertion(+), 1 deletion(-) rename cmake/{CMakeLists.libjpeg => CMakeLists.jpeg} (100%) diff --git a/cmake/CMakeLists.libjpeg b/cmake/CMakeLists.jpeg similarity index 100% rename from cmake/CMakeLists.libjpeg rename to cmake/CMakeLists.jpeg diff --git a/cmake/CMakeLists.txt b/cmake/CMakeLists.txt index ff187c6366..cffc854f0f 100644 --- a/cmake/CMakeLists.txt +++ b/cmake/CMakeLists.txt @@ -424,7 +424,7 @@ if((NOT JPEG_FOUND) AND (CMAKE_VERSION VERSION_GREATER_EQUAL 3.16)) mark_as_advanced(LIBJPEG_URL) mark_as_advanced(LIBJPEG_MD5) include(ExternalCMakeProject) - ExternalCmakeProject(libjpeg ${LIBJPEG_URL} ${LIBJPEG_MD5} libjpeg-turbo . CMakeLists.libjpeg) + ExternalCmakeProject(libjpeg ${LIBJPEG_URL} ${LIBJPEG_MD5} libjpeg-turbo . CMakeLists.jpeg) add_library(JPEG::JPEG ALIAS jpeg-static) target_include_directories(lammps PRIVATE "${CMAKE_BINARY_DIR}/_deps/libjpeg-src") target_include_directories(lammps PRIVATE "${CMAKE_BINARY_DIR}/_deps/libjpeg-build") From 0069c4b56277f6bbb26ea79ff83823c27d57acc3 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sun, 22 May 2022 18:10:26 -0400 Subject: [PATCH 194/585] update docs for automatic jpeg/png/zlib library download and build with CMake --- doc/src/Build_settings.rst | 28 ++++++++++++++++------------ 1 file changed, 16 insertions(+), 12 deletions(-) diff --git a/doc/src/Build_settings.rst b/doc/src/Build_settings.rst index 6053bdbf8a..76ef308d2c 100644 --- a/doc/src/Build_settings.rst +++ b/doc/src/Build_settings.rst @@ -287,8 +287,8 @@ Output of JPG, PNG, and movie files The :doc:`dump image ` command has options to output JPEG or PNG image files. Likewise the :doc:`dump movie ` command -outputs movie files in MPEG format. Using these options requires the -following settings: +outputs movie files in a variety of movie formats. Using these options +requires the following settings: .. tabs:: @@ -297,15 +297,15 @@ following settings: .. code-block:: bash -D WITH_JPEG=value # yes or no - # default = yes if CMake finds JPEG files, else no + # default = yes -D WITH_PNG=value # yes or no - # default = yes if CMake finds PNG and ZLIB files, else no + # default = yes -D WITH_FFMPEG=value # yes or no # default = yes if CMake can find ffmpeg, else no - Usually these settings are all that is needed. If CMake cannot - find the graphics header, library, executable files, you can set - these variables: + Usually these settings are all that is needed. If those libraries + or executables are installed but CMake cannot find the graphics header, + library, or executable files, you can set these variables accordingly: .. code-block:: bash @@ -317,6 +317,9 @@ following settings: -D ZLIB_LIBRARY=path # path to libz.a (.so) file -D FFMPEG_EXECUTABLE=path # path to ffmpeg executable + Otherwise, CMake will attempt to download, build, and link with + jpeg, png, and zlib libraries statically from source code. + .. tab:: Traditional make .. code-block:: make @@ -328,11 +331,12 @@ following settings: JPG_LIB = -ljpeg -lpng -lz # library names As with CMake, you do not need to set ``JPG_INC`` or ``JPG_PATH``, - if make can find the graphics header and library files. You must - specify ``JPG_LIB`` with a list of graphics libraries to include - in the link. You must insure ffmpeg is in a directory where - LAMMPS can find it at runtime, that is a directory in your PATH - environment variable. + if make can find the graphics header and library files in their + default system locations. You must specify ``JPG_LIB`` with a + list of graphics libraries to include in the link. You must make + certain that the ffmpeg executable (or ffmpeg.exe on Windows) is + in a directory where LAMMPS can find it at runtime; that is + usually a directory list in your ``PATH`` environment variable. Using ``ffmpeg`` to output movie files requires that your machine supports the "popen" function in the standard runtime library. From 9f7833668ac2f7075b6542b6b6fdafd31a24395f Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sun, 22 May 2022 18:15:10 -0400 Subject: [PATCH 195/585] whitespace --- cmake/Modules/Packages/COMPRESS.cmake | 2 +- doc/src/Build_settings.rst | 2 +- 2 files changed, 2 insertions(+), 2 deletions(-) diff --git a/cmake/Modules/Packages/COMPRESS.cmake b/cmake/Modules/Packages/COMPRESS.cmake index 599f1d0079..d9e2ccf7ad 100644 --- a/cmake/Modules/Packages/COMPRESS.cmake +++ b/cmake/Modules/Packages/COMPRESS.cmake @@ -10,4 +10,4 @@ if(PkgConfig_FOUND) target_compile_definitions(lammps PRIVATE -DLAMMPS_ZSTD) target_link_libraries(lammps PRIVATE PkgConfig::Zstd) endif() -endif() \ No newline at end of file +endif() diff --git a/doc/src/Build_settings.rst b/doc/src/Build_settings.rst index 76ef308d2c..bdae796bae 100644 --- a/doc/src/Build_settings.rst +++ b/doc/src/Build_settings.rst @@ -319,7 +319,7 @@ requires the following settings: Otherwise, CMake will attempt to download, build, and link with jpeg, png, and zlib libraries statically from source code. - + .. tab:: Traditional make .. code-block:: make From b461a49eee5caa45f6c6457d37ac82d8704652fb Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 23 May 2022 11:14:17 -0400 Subject: [PATCH 196/585] use _EXECUTABLE consistently instead of _BINARY --- unittest/formats/CMakeLists.txt | 32 +++++++++---------- .../formats/compressed_dump_test_main.cpp | 4 +-- unittest/formats/test_atom_styles.cpp | 5 ++- unittest/formats/test_dump_atom.cpp | 24 +++++++------- .../formats/test_dump_atom_compressed.cpp | 24 +++++++------- unittest/formats/test_dump_cfg_compressed.cpp | 14 ++++---- unittest/formats/test_dump_custom.cpp | 12 +++---- .../formats/test_dump_custom_compressed.cpp | 16 +++++----- unittest/formats/test_dump_local.cpp | 6 ++-- .../formats/test_dump_local_compressed.cpp | 18 +++++------ unittest/formats/test_dump_netcdf.cpp | 12 +++---- unittest/formats/test_dump_xyz_compressed.cpp | 12 +++---- 12 files changed, 89 insertions(+), 90 deletions(-) diff --git a/unittest/formats/CMakeLists.txt b/unittest/formats/CMakeLists.txt index f1408de4d7..5b5dd056c9 100644 --- a/unittest/formats/CMakeLists.txt +++ b/unittest/formats/CMakeLists.txt @@ -64,39 +64,39 @@ if(PKG_COMPRESS AND GZIP_FOUND) target_link_libraries(test_dump_xyz_compressed PRIVATE lammps GTest::GMock) add_test(NAME DumpAtomGZ COMMAND test_dump_atom_compressed gz) - set_tests_properties(DumpAtomGZ PROPERTIES ENVIRONMENT "LAMMPS_POTENTIALS=${LAMMPS_POTENTIALS_DIR};COMPRESS_BINARY=${GZIP_EXECUTABLE}") + set_tests_properties(DumpAtomGZ PROPERTIES ENVIRONMENT "LAMMPS_POTENTIALS=${LAMMPS_POTENTIALS_DIR};COMPRESS_EXECUTABLE=${GZIP_EXECUTABLE}") add_test(NAME DumpCustomGZ COMMAND test_dump_custom_compressed gz) - set_tests_properties(DumpCustomGZ PROPERTIES ENVIRONMENT "LAMMPS_POTENTIALS=${LAMMPS_POTENTIALS_DIR};COMPRESS_BINARY=${GZIP_EXECUTABLE}") + set_tests_properties(DumpCustomGZ PROPERTIES ENVIRONMENT "LAMMPS_POTENTIALS=${LAMMPS_POTENTIALS_DIR};COMPRESS_EXECUTABLE=${GZIP_EXECUTABLE}") add_test(NAME DumpCfgGZ COMMAND test_dump_cfg_compressed gz) - set_tests_properties(DumpCfgGZ PROPERTIES ENVIRONMENT "LAMMPS_POTENTIALS=${LAMMPS_POTENTIALS_DIR};COMPRESS_BINARY=${GZIP_EXECUTABLE}") + set_tests_properties(DumpCfgGZ PROPERTIES ENVIRONMENT "LAMMPS_POTENTIALS=${LAMMPS_POTENTIALS_DIR};COMPRESS_EXECUTABLE=${GZIP_EXECUTABLE}") add_test(NAME DumpLocalGZ COMMAND test_dump_local_compressed gz) - set_tests_properties(DumpLocalGZ PROPERTIES ENVIRONMENT "LAMMPS_POTENTIALS=${LAMMPS_POTENTIALS_DIR};COMPRESS_BINARY=${GZIP_EXECUTABLE}") + set_tests_properties(DumpLocalGZ PROPERTIES ENVIRONMENT "LAMMPS_POTENTIALS=${LAMMPS_POTENTIALS_DIR};COMPRESS_EXECUTABLE=${GZIP_EXECUTABLE}") add_test(NAME DumpXYZGZ COMMAND test_dump_xyz_compressed gz) - set_tests_properties(DumpXYZGZ PROPERTIES ENVIRONMENT "LAMMPS_POTENTIALS=${LAMMPS_POTENTIALS_DIR};COMPRESS_BINARY=${GZIP_EXECUTABLE}") + set_tests_properties(DumpXYZGZ PROPERTIES ENVIRONMENT "LAMMPS_POTENTIALS=${LAMMPS_POTENTIALS_DIR};COMPRESS_EXECUTABLE=${GZIP_EXECUTABLE}") - find_package(PkgConfig REQUIRED) + find_package(PkgConfig) pkg_check_modules(Zstd IMPORTED_TARGET libzstd>=1.4) - find_program(ZSTD_BINARY NAMES zstd) + find_program(ZSTD_EXECUTABLE NAMES zstd) - if(Zstd_FOUND AND ZSTD_BINARY) + if(Zstd_FOUND AND ZSTD_EXECUTABLE) add_test(NAME DumpAtomZstd COMMAND test_dump_atom_compressed zstd) - set_tests_properties(DumpAtomZstd PROPERTIES ENVIRONMENT "LAMMPS_POTENTIALS=${LAMMPS_POTENTIALS_DIR};COMPRESS_BINARY=${ZSTD_BINARY}") + set_tests_properties(DumpAtomZstd PROPERTIES ENVIRONMENT "LAMMPS_POTENTIALS=${LAMMPS_POTENTIALS_DIR};COMPRESS_EXECUTABLE=${ZSTD_EXECUTABLE}") add_test(NAME DumpCustomZstd COMMAND test_dump_custom_compressed zstd) - set_tests_properties(DumpCustomZstd PROPERTIES ENVIRONMENT "LAMMPS_POTENTIALS=${LAMMPS_POTENTIALS_DIR};COMPRESS_BINARY=${ZSTD_BINARY}") + set_tests_properties(DumpCustomZstd PROPERTIES ENVIRONMENT "LAMMPS_POTENTIALS=${LAMMPS_POTENTIALS_DIR};COMPRESS_EXECUTABLE=${ZSTD_EXECUTABLE}") add_test(NAME DumpCfgZstd COMMAND test_dump_cfg_compressed zstd) - set_tests_properties(DumpCfgZstd PROPERTIES ENVIRONMENT "LAMMPS_POTENTIALS=${LAMMPS_POTENTIALS_DIR};COMPRESS_BINARY=${ZSTD_BINARY}") + set_tests_properties(DumpCfgZstd PROPERTIES ENVIRONMENT "LAMMPS_POTENTIALS=${LAMMPS_POTENTIALS_DIR};COMPRESS_EXECUTABLE=${ZSTD_EXECUTABLE}") add_test(NAME DumpLocalZstd COMMAND test_dump_local_compressed zstd) - set_tests_properties(DumpLocalZstd PROPERTIES ENVIRONMENT "LAMMPS_POTENTIALS=${LAMMPS_POTENTIALS_DIR};COMPRESS_BINARY=${ZSTD_BINARY}") + set_tests_properties(DumpLocalZstd PROPERTIES ENVIRONMENT "LAMMPS_POTENTIALS=${LAMMPS_POTENTIALS_DIR};COMPRESS_EXECUTABLE=${ZSTD_EXECUTABLE}") add_test(NAME DumpXYZZstd COMMAND test_dump_xyz_compressed zstd) - set_tests_properties(DumpXYZZstd PROPERTIES ENVIRONMENT "LAMMPS_POTENTIALS=${LAMMPS_POTENTIALS_DIR};COMPRESS_BINARY=${ZSTD_BINARY}") + set_tests_properties(DumpXYZZstd PROPERTIES ENVIRONMENT "LAMMPS_POTENTIALS=${LAMMPS_POTENTIALS_DIR};COMPRESS_EXECUTABLE=${ZSTD_EXECUTABLE}") endif() endif() @@ -121,11 +121,11 @@ if(PKG_NETCDF) target_link_libraries(test_dump_netcdf PRIVATE lammps GTest::GMock) add_test(NAME DumpNetCDF COMMAND test_dump_netcdf) if(NOT (NCDUMP STREQUAL "NCDUMP-NOTFOUND")) - set_tests_properties(DumpNetCDF PROPERTIES ENVIRONMENT "LAMMPS_POTENTIALS=${LAMMPS_POTENTIALS_DIR};NCDUMP_BINARY=${NCDUMP}") + set_tests_properties(DumpNetCDF PROPERTIES ENVIRONMENT "LAMMPS_POTENTIALS=${LAMMPS_POTENTIALS_DIR};NCDUMP_EXECUTABLE=${NCDUMP}") endif() endif() if(BUILD_TOOLS) - set_tests_properties(DumpAtom PROPERTIES ENVIRONMENT "BINARY2TXT_BINARY=$") - set_tests_properties(DumpCustom PROPERTIES ENVIRONMENT "BINARY2TXT_BINARY=$") + set_tests_properties(DumpAtom PROPERTIES ENVIRONMENT "BINARY2TXT_EXECUTABLE=$") + set_tests_properties(DumpCustom PROPERTIES ENVIRONMENT "BINARY2TXT_EXECUTABLE=$") endif() diff --git a/unittest/formats/compressed_dump_test_main.cpp b/unittest/formats/compressed_dump_test_main.cpp index e85f616776..c96682d8b7 100644 --- a/unittest/formats/compressed_dump_test_main.cpp +++ b/unittest/formats/compressed_dump_test_main.cpp @@ -22,7 +22,7 @@ const char *COMPRESS_SUFFIX = nullptr; const char *COMPRESS_EXTENSION = nullptr; -char *COMPRESS_BINARY = nullptr; +char *COMPRESS_EXECUTABLE = nullptr; bool verbose = false; int main(int argc, char **argv) @@ -46,7 +46,7 @@ int main(int argc, char **argv) return 1; } - COMPRESS_BINARY = getenv("COMPRESS_BINARY"); + COMPRESS_EXECUTABLE = getenv("COMPRESS_EXECUTABLE"); // handle arguments passed via environment variable if (const char *var = getenv("TEST_ARGS")) { diff --git a/unittest/formats/test_atom_styles.cpp b/unittest/formats/test_atom_styles.cpp index c4c79238aa..c712ffd763 100644 --- a/unittest/formats/test_atom_styles.cpp +++ b/unittest/formats/test_atom_styles.cpp @@ -2123,7 +2123,7 @@ TEST_F(AtomStyleTest, body_nparticle) "12.0 0.0 12.0 0.0 0.0 0.0\n" "0.0 1.0 0.0\n" "0.0 -3.0 0.0\n"; - FILE *fp = fopen("input_atom_styles.data", "w"); + FILE *fp = fopen("input_atom_styles.data", "w"); fputs(data_file, fp); fclose(fp); BEGIN_HIDE_OUTPUT(); @@ -5159,7 +5159,7 @@ TEST_F(AtomStyleTest, oxdna) EXPECT_NEAR(bonus[9].shape[1], 0.5869922515711705, EPSILON); EXPECT_NEAR(bonus[9].shape[2], 0.5869922515711705, EPSILON); - EXPECT_NEAR(bonus[0].quat[0], 0.9890278201757743, EPSILON); + EXPECT_NEAR(bonus[0].quat[0], 0.9890278201757743, EPSILON); EXPECT_NEAR(bonus[0].quat[1], 0.01779228232037064, EPSILON); EXPECT_NEAR(bonus[0].quat[2], -0.14337734159225404, EPSILON); EXPECT_NEAR(bonus[0].quat[3], 0.030827642240801516, EPSILON); @@ -5246,7 +5246,6 @@ TEST_F(AtomStyleTest, oxdna) ASSERT_EQ(id5p[GETIDX(10)], -1); END_HIDE_OUTPUT(); - } } // namespace LAMMPS_NS diff --git a/unittest/formats/test_dump_atom.cpp b/unittest/formats/test_dump_atom.cpp index 6303d2c019..c9e5223f19 100644 --- a/unittest/formats/test_dump_atom.cpp +++ b/unittest/formats/test_dump_atom.cpp @@ -25,8 +25,8 @@ using ::testing::Eq; -char *BINARY2TXT_BINARY = nullptr; -bool verbose = false; +char *BINARY2TXT_EXECUTABLE = nullptr; +bool verbose = false; class DumpAtomTest : public MeltTest { std::string dump_style = "atom"; @@ -100,7 +100,7 @@ public: std::string convert_binary_to_text(std::string binary_file) { BEGIN_HIDE_OUTPUT(); - std::string cmdline = fmt::format("{} {}", BINARY2TXT_BINARY, binary_file); + std::string cmdline = fmt::format("{} {}", BINARY2TXT_EXECUTABLE, binary_file); system(cmdline.c_str()); END_HIDE_OUTPUT(); return fmt::format("{}.txt", binary_file); @@ -328,7 +328,7 @@ TEST_F(DumpAtomTest, triclinic_with_image_run0) TEST_F(DumpAtomTest, binary_run0) { - if (!BINARY2TXT_BINARY) GTEST_SKIP(); + if (!BINARY2TXT_EXECUTABLE) GTEST_SKIP(); auto text_file = text_dump_filename("run0"); auto binary_file = binary_dump_filename("run0"); @@ -349,7 +349,7 @@ TEST_F(DumpAtomTest, binary_run0) TEST_F(DumpAtomTest, binary_with_units_run0) { - if (!BINARY2TXT_BINARY) GTEST_SKIP(); + if (!BINARY2TXT_EXECUTABLE) GTEST_SKIP(); auto text_file = text_dump_filename("with_units_run0"); auto binary_file = binary_dump_filename("with_units_run0"); @@ -370,7 +370,7 @@ TEST_F(DumpAtomTest, binary_with_units_run0) TEST_F(DumpAtomTest, binary_with_time_run0) { - if (!BINARY2TXT_BINARY) GTEST_SKIP(); + if (!BINARY2TXT_EXECUTABLE) GTEST_SKIP(); auto text_file = text_dump_filename("with_time_run0"); auto binary_file = binary_dump_filename("with_time_run0"); @@ -391,7 +391,7 @@ TEST_F(DumpAtomTest, binary_with_time_run0) TEST_F(DumpAtomTest, binary_triclinic_run0) { - if (!BINARY2TXT_BINARY) GTEST_SKIP(); + if (!BINARY2TXT_EXECUTABLE) GTEST_SKIP(); auto text_file = text_dump_filename("tri_run0"); auto binary_file = binary_dump_filename("tri_run0"); @@ -413,7 +413,7 @@ TEST_F(DumpAtomTest, binary_triclinic_run0) TEST_F(DumpAtomTest, binary_triclinic_with_units_run0) { - if (!BINARY2TXT_BINARY) GTEST_SKIP(); + if (!BINARY2TXT_EXECUTABLE) GTEST_SKIP(); auto text_file = text_dump_filename("tri_with_units_run0"); auto binary_file = binary_dump_filename("tri_with_units_run0"); @@ -435,7 +435,7 @@ TEST_F(DumpAtomTest, binary_triclinic_with_units_run0) TEST_F(DumpAtomTest, binary_triclinic_with_time_run0) { - if (!BINARY2TXT_BINARY) GTEST_SKIP(); + if (!BINARY2TXT_EXECUTABLE) GTEST_SKIP(); auto text_file = text_dump_filename("tri_with_time_run0"); auto binary_file = binary_dump_filename("tri_with_time_run0"); @@ -457,7 +457,7 @@ TEST_F(DumpAtomTest, binary_triclinic_with_time_run0) TEST_F(DumpAtomTest, binary_triclinic_with_image_run0) { - if (!BINARY2TXT_BINARY) GTEST_SKIP(); + if (!BINARY2TXT_EXECUTABLE) GTEST_SKIP(); auto text_file = text_dump_filename("tri_with_image_run0"); auto binary_file = binary_dump_filename("tri_with_image_run0"); @@ -649,7 +649,7 @@ TEST_F(DumpAtomTest, write_dump) TEST_F(DumpAtomTest, binary_write_dump) { - if (!BINARY2TXT_BINARY) GTEST_SKIP(); + if (!BINARY2TXT_EXECUTABLE) GTEST_SKIP(); auto reference = binary_dump_filename("write_run0_ref"); auto dump_file = fmt::format("write_{}", binary_dump_filename("write_dump_atom_run*_p%")); @@ -693,7 +693,7 @@ int main(int argc, char **argv) } } - BINARY2TXT_BINARY = getenv("BINARY2TXT_BINARY"); + BINARY2TXT_EXECUTABLE = getenv("BINARY2TXT_EXECUTABLE"); if ((argc > 1) && (strcmp(argv[1], "-v") == 0)) verbose = true; diff --git a/unittest/formats/test_dump_atom_compressed.cpp b/unittest/formats/test_dump_atom_compressed.cpp index dcc3d49d6e..419ad0eb81 100644 --- a/unittest/formats/test_dump_atom_compressed.cpp +++ b/unittest/formats/test_dump_atom_compressed.cpp @@ -33,7 +33,7 @@ public: TEST_F(DumpAtomCompressTest, compressed_run0) { - if (!COMPRESS_BINARY) GTEST_SKIP(); + if (!COMPRESS_EXECUTABLE) GTEST_SKIP(); auto text_file = text_dump_filename("run0.melt"); auto compressed_file = compressed_dump_filename("run0.melt"); @@ -62,7 +62,7 @@ TEST_F(DumpAtomCompressTest, compressed_run0) TEST_F(DumpAtomCompressTest, compressed_no_buffer_run0) { - if (!COMPRESS_BINARY) GTEST_SKIP(); + if (!COMPRESS_EXECUTABLE) GTEST_SKIP(); auto text_file = text_dump_filename("no_buffer_run0.melt"); auto compressed_file = compressed_dump_filename("no_buffer_run0.melt"); @@ -91,7 +91,7 @@ TEST_F(DumpAtomCompressTest, compressed_no_buffer_run0) TEST_F(DumpAtomCompressTest, compressed_multi_file_run1) { - if (!COMPRESS_BINARY) GTEST_SKIP(); + if (!COMPRESS_EXECUTABLE) GTEST_SKIP(); auto base_name = "multi_file_run1_*.melt"; auto base_name_0 = "multi_file_run1_0.melt"; @@ -131,7 +131,7 @@ TEST_F(DumpAtomCompressTest, compressed_multi_file_run1) TEST_F(DumpAtomCompressTest, compressed_multi_file_with_pad_run1) { - if (!COMPRESS_BINARY) GTEST_SKIP(); + if (!COMPRESS_EXECUTABLE) GTEST_SKIP(); auto base_name = "multi_file_pad_run1_*.melt"; auto base_name_0 = "multi_file_pad_run1_000.melt"; @@ -172,7 +172,7 @@ TEST_F(DumpAtomCompressTest, compressed_multi_file_with_pad_run1) TEST_F(DumpAtomCompressTest, compressed_multi_file_with_maxfiles_run1) { - if (!COMPRESS_BINARY) GTEST_SKIP(); + if (!COMPRESS_EXECUTABLE) GTEST_SKIP(); auto base_name = "multi_file_maxfiles_run1_*.melt"; auto base_name_0 = "multi_file_maxfiles_run1_0.melt"; @@ -218,7 +218,7 @@ TEST_F(DumpAtomCompressTest, compressed_multi_file_with_maxfiles_run1) TEST_F(DumpAtomCompressTest, compressed_with_units_run0) { - if (!COMPRESS_BINARY) GTEST_SKIP(); + if (!COMPRESS_EXECUTABLE) GTEST_SKIP(); auto base_name = "with_units_run0.melt"; auto text_file = text_dump_filename(base_name); @@ -242,7 +242,7 @@ TEST_F(DumpAtomCompressTest, compressed_with_units_run0) TEST_F(DumpAtomCompressTest, compressed_with_time_run0) { - if (!COMPRESS_BINARY) GTEST_SKIP(); + if (!COMPRESS_EXECUTABLE) GTEST_SKIP(); auto base_name = "with_time_run0.melt"; auto text_file = text_dump_filename(base_name); @@ -266,7 +266,7 @@ TEST_F(DumpAtomCompressTest, compressed_with_time_run0) TEST_F(DumpAtomCompressTest, compressed_triclinic_run0) { - if (!COMPRESS_BINARY) GTEST_SKIP(); + if (!COMPRESS_EXECUTABLE) GTEST_SKIP(); auto base_name = "tri_run0.melt"; auto text_file = text_dump_filename(base_name); @@ -291,7 +291,7 @@ TEST_F(DumpAtomCompressTest, compressed_triclinic_run0) TEST_F(DumpAtomCompressTest, compressed_triclinic_with_units_run0) { - if (!COMPRESS_BINARY) GTEST_SKIP(); + if (!COMPRESS_EXECUTABLE) GTEST_SKIP(); auto base_name = "tri_with_units_run0.melt"; auto text_file = text_dump_filename(base_name); @@ -316,7 +316,7 @@ TEST_F(DumpAtomCompressTest, compressed_triclinic_with_units_run0) TEST_F(DumpAtomCompressTest, compressed_triclinic_with_time_run0) { - if (!COMPRESS_BINARY) GTEST_SKIP(); + if (!COMPRESS_EXECUTABLE) GTEST_SKIP(); auto base_name = "tri_with_time_run0.melt"; auto text_file = text_dump_filename(base_name); @@ -341,7 +341,7 @@ TEST_F(DumpAtomCompressTest, compressed_triclinic_with_time_run0) TEST_F(DumpAtomCompressTest, compressed_triclinic_with_image_run0) { - if (!COMPRESS_BINARY) GTEST_SKIP(); + if (!COMPRESS_EXECUTABLE) GTEST_SKIP(); auto base_name = "tri_with_image_run0.melt"; auto text_file = text_dump_filename(base_name); @@ -394,7 +394,7 @@ TEST_F(DumpAtomCompressTest, compressed_modify_multi_bad_param) TEST_F(DumpAtomCompressTest, compressed_modify_clevel_run0) { - if (!COMPRESS_BINARY) GTEST_SKIP(); + if (!COMPRESS_EXECUTABLE) GTEST_SKIP(); auto base_name = "modify_clevel_run0.melt"; auto text_file = text_dump_filename(base_name); diff --git a/unittest/formats/test_dump_cfg_compressed.cpp b/unittest/formats/test_dump_cfg_compressed.cpp index 67d7084ab9..29afec06ce 100644 --- a/unittest/formats/test_dump_cfg_compressed.cpp +++ b/unittest/formats/test_dump_cfg_compressed.cpp @@ -33,7 +33,7 @@ public: TEST_F(DumpCfgCompressTest, compressed_run0) { - if (!COMPRESS_BINARY) GTEST_SKIP(); + if (!COMPRESS_EXECUTABLE) GTEST_SKIP(); auto base_name = "run*.melt.cfg"; auto text_files = text_dump_filename(base_name); @@ -67,7 +67,7 @@ TEST_F(DumpCfgCompressTest, compressed_run0) TEST_F(DumpCfgCompressTest, compressed_no_buffer_run0) { - if (!COMPRESS_BINARY) GTEST_SKIP(); + if (!COMPRESS_EXECUTABLE) GTEST_SKIP(); auto base_name = "no_buffer_run*.melt.cfg"; auto text_files = text_dump_filename(base_name); @@ -101,7 +101,7 @@ TEST_F(DumpCfgCompressTest, compressed_no_buffer_run0) TEST_F(DumpCfgCompressTest, compressed_unwrap_run0) { - if (!COMPRESS_BINARY) GTEST_SKIP(); + if (!COMPRESS_EXECUTABLE) GTEST_SKIP(); auto base_name = "unwrap_run*.melt.cfg"; auto text_files = text_dump_filename(base_name); @@ -130,7 +130,7 @@ TEST_F(DumpCfgCompressTest, compressed_unwrap_run0) TEST_F(DumpCfgCompressTest, compressed_multi_file_run1) { - if (!COMPRESS_BINARY) GTEST_SKIP(); + if (!COMPRESS_EXECUTABLE) GTEST_SKIP(); auto base_name = "multi_file_run1_*.melt.cfg"; auto base_name_0 = "multi_file_run1_0.melt.cfg"; @@ -172,7 +172,7 @@ TEST_F(DumpCfgCompressTest, compressed_multi_file_run1) TEST_F(DumpCfgCompressTest, compressed_multi_file_with_pad_run1) { - if (!COMPRESS_BINARY) GTEST_SKIP(); + if (!COMPRESS_EXECUTABLE) GTEST_SKIP(); auto base_name = "multi_file_pad_run1_*.melt.cfg"; auto base_name_0 = "multi_file_pad_run1_000.melt.cfg"; @@ -214,7 +214,7 @@ TEST_F(DumpCfgCompressTest, compressed_multi_file_with_pad_run1) TEST_F(DumpCfgCompressTest, compressed_multi_file_with_maxfiles_run1) { - if (!COMPRESS_BINARY) GTEST_SKIP(); + if (!COMPRESS_EXECUTABLE) GTEST_SKIP(); auto base_name = "multi_file_maxfiles_run1_*.melt.cfg"; auto base_name_0 = "multi_file_maxfiles_run1_0.melt.cfg"; @@ -292,7 +292,7 @@ TEST_F(DumpCfgCompressTest, compressed_modify_multi_bad_param) TEST_F(DumpCfgCompressTest, compressed_modify_clevel_run0) { - if (!COMPRESS_BINARY) GTEST_SKIP(); + if (!COMPRESS_EXECUTABLE) GTEST_SKIP(); auto base_name = "modify_clevel_run*.melt.cfg"; auto base_name_0 = "modify_clevel_run0.melt.cfg"; diff --git a/unittest/formats/test_dump_custom.cpp b/unittest/formats/test_dump_custom.cpp index 40e22f5a11..ee297b194e 100644 --- a/unittest/formats/test_dump_custom.cpp +++ b/unittest/formats/test_dump_custom.cpp @@ -23,8 +23,8 @@ using ::testing::Eq; -char *BINARY2TXT_BINARY = nullptr; -bool verbose = false; +char *BINARY2TXT_EXECUTABLE = nullptr; +bool verbose = false; class DumpCustomTest : public MeltTest { std::string dump_style = "custom"; @@ -100,7 +100,7 @@ public: std::string convert_binary_to_text(std::string binary_file) { BEGIN_HIDE_OUTPUT(); - std::string cmdline = fmt::format("{} {}", BINARY2TXT_BINARY, binary_file); + std::string cmdline = fmt::format("{} {}", BINARY2TXT_EXECUTABLE, binary_file); system(cmdline.c_str()); END_HIDE_OUTPUT(); return fmt::format("{}.txt", binary_file); @@ -210,7 +210,7 @@ TEST_F(DumpCustomTest, custom_run0) TEST_F(DumpCustomTest, binary_run1) { - if (!BINARY2TXT_BINARY) GTEST_SKIP(); + if (!BINARY2TXT_EXECUTABLE) GTEST_SKIP(); auto text_file = text_dump_filename("run1"); auto binary_file = binary_dump_filename("run1"); @@ -251,7 +251,7 @@ TEST_F(DumpCustomTest, triclinic_run1) TEST_F(DumpCustomTest, binary_triclinic_run1) { - if (!BINARY2TXT_BINARY) GTEST_SKIP(); + if (!BINARY2TXT_EXECUTABLE) GTEST_SKIP(); auto text_file = text_dump_filename("tri_run1"); auto binary_file = binary_dump_filename("tri_run1"); @@ -399,7 +399,7 @@ int main(int argc, char **argv) } } - BINARY2TXT_BINARY = getenv("BINARY2TXT_BINARY"); + BINARY2TXT_EXECUTABLE = getenv("BINARY2TXT_EXECUTABLE"); if ((argc > 1) && (strcmp(argv[1], "-v") == 0)) verbose = true; diff --git a/unittest/formats/test_dump_custom_compressed.cpp b/unittest/formats/test_dump_custom_compressed.cpp index a69fd98c41..fec751b358 100644 --- a/unittest/formats/test_dump_custom_compressed.cpp +++ b/unittest/formats/test_dump_custom_compressed.cpp @@ -29,7 +29,7 @@ public: TEST_F(DumpCustomCompressTest, compressed_run1) { - if (!COMPRESS_BINARY) GTEST_SKIP(); + if (!COMPRESS_EXECUTABLE) GTEST_SKIP(); auto base_name = "custom_run1.melt"; auto text_file = text_dump_filename(base_name); @@ -59,7 +59,7 @@ TEST_F(DumpCustomCompressTest, compressed_run1) TEST_F(DumpCustomCompressTest, compressed_with_time_run1) { - if (!COMPRESS_BINARY) GTEST_SKIP(); + if (!COMPRESS_EXECUTABLE) GTEST_SKIP(); auto base_name = "with_time_custom_run1.melt"; auto text_file = text_dump_filename(base_name); @@ -89,7 +89,7 @@ TEST_F(DumpCustomCompressTest, compressed_with_time_run1) TEST_F(DumpCustomCompressTest, compressed_no_buffer_run1) { - if (!COMPRESS_BINARY) GTEST_SKIP(); + if (!COMPRESS_EXECUTABLE) GTEST_SKIP(); auto base_name = "no_buffer_custom_run1.melt"; auto text_file = text_dump_filename(base_name); @@ -119,7 +119,7 @@ TEST_F(DumpCustomCompressTest, compressed_no_buffer_run1) TEST_F(DumpCustomCompressTest, compressed_triclinic_run1) { - if (!COMPRESS_BINARY) GTEST_SKIP(); + if (!COMPRESS_EXECUTABLE) GTEST_SKIP(); auto base_name = "custom_tri_run1.melt"; auto text_file = text_dump_filename(base_name); @@ -146,7 +146,7 @@ TEST_F(DumpCustomCompressTest, compressed_triclinic_run1) TEST_F(DumpCustomCompressTest, compressed_multi_file_run1) { - if (!COMPRESS_BINARY) GTEST_SKIP(); + if (!COMPRESS_EXECUTABLE) GTEST_SKIP(); auto base_name = "multi_file_run1_*.melt.custom"; auto base_name_0 = "multi_file_run1_0.melt.custom"; @@ -188,7 +188,7 @@ TEST_F(DumpCustomCompressTest, compressed_multi_file_run1) TEST_F(DumpCustomCompressTest, compressed_multi_file_with_pad_run1) { - if (!COMPRESS_BINARY) GTEST_SKIP(); + if (!COMPRESS_EXECUTABLE) GTEST_SKIP(); auto base_name = "multi_file_pad_run1_*.melt.custom"; auto base_name_0 = "multi_file_pad_run1_000.melt.custom"; @@ -230,7 +230,7 @@ TEST_F(DumpCustomCompressTest, compressed_multi_file_with_pad_run1) TEST_F(DumpCustomCompressTest, compressed_multi_file_with_maxfiles_run1) { - if (!COMPRESS_BINARY) GTEST_SKIP(); + if (!COMPRESS_EXECUTABLE) GTEST_SKIP(); auto base_name = "multi_file_maxfiles_run1_*.melt.custom"; auto base_name_0 = "multi_file_maxfiles_run1_0.melt.custom"; @@ -304,7 +304,7 @@ TEST_F(DumpCustomCompressTest, compressed_modify_multi_bad_param) TEST_F(DumpCustomCompressTest, compressed_modify_clevel_run0) { - if (!COMPRESS_BINARY) GTEST_SKIP(); + if (!COMPRESS_EXECUTABLE) GTEST_SKIP(); auto base_name = "modify_clevel_run0.melt.custom"; auto text_file = text_dump_filename(base_name); diff --git a/unittest/formats/test_dump_local.cpp b/unittest/formats/test_dump_local.cpp index 3b8b36f06f..5471145309 100644 --- a/unittest/formats/test_dump_local.cpp +++ b/unittest/formats/test_dump_local.cpp @@ -25,8 +25,8 @@ using ::testing::Eq; -char *BINARY2TXT_BINARY = nullptr; -bool verbose = false; +char *BINARY2TXT_EXECUTABLE = nullptr; +bool verbose = false; class DumpLocalTest : public MeltTest { std::string dump_style = "local"; @@ -253,7 +253,7 @@ int main(int argc, char **argv) } } - BINARY2TXT_BINARY = getenv("BINARY2TXT_BINARY"); + BINARY2TXT_EXECUTABLE = getenv("BINARY2TXT_EXECUTABLE"); if ((argc > 1) && (strcmp(argv[1], "-v") == 0)) verbose = true; diff --git a/unittest/formats/test_dump_local_compressed.cpp b/unittest/formats/test_dump_local_compressed.cpp index 2f4c6086c2..b1161927c6 100644 --- a/unittest/formats/test_dump_local_compressed.cpp +++ b/unittest/formats/test_dump_local_compressed.cpp @@ -38,7 +38,7 @@ public: TEST_F(DumpLocalCompressTest, compressed_run0) { - if (!COMPRESS_BINARY) GTEST_SKIP(); + if (!COMPRESS_EXECUTABLE) GTEST_SKIP(); auto base_name = "run*.melt.local"; auto base_name_0 = "run0.melt.local"; @@ -71,7 +71,7 @@ TEST_F(DumpLocalCompressTest, compressed_run0) TEST_F(DumpLocalCompressTest, compressed_no_buffer_run0) { - if (!COMPRESS_BINARY) GTEST_SKIP(); + if (!COMPRESS_EXECUTABLE) GTEST_SKIP(); auto base_name = "no_buffer_run*.melt.local"; auto base_name_0 = "no_buffer_run0.melt.local"; @@ -104,7 +104,7 @@ TEST_F(DumpLocalCompressTest, compressed_no_buffer_run0) TEST_F(DumpLocalCompressTest, compressed_with_time_run0) { - if (!COMPRESS_BINARY) GTEST_SKIP(); + if (!COMPRESS_EXECUTABLE) GTEST_SKIP(); auto base_name = "with_time_run*.melt.local"; auto base_name_0 = "with_time_run0.melt.local"; @@ -137,7 +137,7 @@ TEST_F(DumpLocalCompressTest, compressed_with_time_run0) TEST_F(DumpLocalCompressTest, compressed_with_units_run0) { - if (!COMPRESS_BINARY) GTEST_SKIP(); + if (!COMPRESS_EXECUTABLE) GTEST_SKIP(); auto base_name = "with_units_run*.melt.local"; auto base_name_0 = "with_units_run0.melt.local"; @@ -170,7 +170,7 @@ TEST_F(DumpLocalCompressTest, compressed_with_units_run0) TEST_F(DumpLocalCompressTest, compressed_triclinic_run0) { - if (!COMPRESS_BINARY) GTEST_SKIP(); + if (!COMPRESS_EXECUTABLE) GTEST_SKIP(); enable_triclinic(); auto base_name = "triclinic_run*.melt.local"; @@ -204,7 +204,7 @@ TEST_F(DumpLocalCompressTest, compressed_triclinic_run0) TEST_F(DumpLocalCompressTest, compressed_multi_file_run1) { - if (!COMPRESS_BINARY) GTEST_SKIP(); + if (!COMPRESS_EXECUTABLE) GTEST_SKIP(); auto base_name = "multi_file_run1_*.melt.local"; auto base_name_0 = "multi_file_run1_0.melt.local"; @@ -246,7 +246,7 @@ TEST_F(DumpLocalCompressTest, compressed_multi_file_run1) TEST_F(DumpLocalCompressTest, compressed_multi_file_with_pad_run1) { - if (!COMPRESS_BINARY) GTEST_SKIP(); + if (!COMPRESS_EXECUTABLE) GTEST_SKIP(); auto base_name = "multi_file_pad_run1_*.melt.local"; auto base_name_0 = "multi_file_pad_run1_000.melt.local"; @@ -288,7 +288,7 @@ TEST_F(DumpLocalCompressTest, compressed_multi_file_with_pad_run1) TEST_F(DumpLocalCompressTest, compressed_multi_file_with_maxfiles_run1) { - if (!COMPRESS_BINARY) GTEST_SKIP(); + if (!COMPRESS_EXECUTABLE) GTEST_SKIP(); auto base_name = "multi_file_maxfiles_run1_*.melt.local"; auto base_name_0 = "multi_file_maxfiles_run1_0.melt.local"; @@ -368,7 +368,7 @@ TEST_F(DumpLocalCompressTest, compressed_modify_multi_bad_param) TEST_F(DumpLocalCompressTest, compressed_modify_clevel_run0) { - if (!COMPRESS_BINARY) GTEST_SKIP(); + if (!COMPRESS_EXECUTABLE) GTEST_SKIP(); auto base_name = "modify_clevel_run0.melt.local"; auto text_file = text_dump_filename(base_name); diff --git a/unittest/formats/test_dump_netcdf.cpp b/unittest/formats/test_dump_netcdf.cpp index 8b4110b352..6d377369ee 100644 --- a/unittest/formats/test_dump_netcdf.cpp +++ b/unittest/formats/test_dump_netcdf.cpp @@ -28,8 +28,8 @@ using ::testing::Eq; -char *NCDUMP_BINARY = nullptr; -bool verbose = false; +char *NCDUMP_EXECUTABLE = nullptr; +bool verbose = false; class DumpNetCDFTest : public MeltTest { std::string dump_style = "netcdf"; @@ -80,7 +80,7 @@ public: std::string convert_binary_to_text(std::string binary_file) { BEGIN_HIDE_OUTPUT(); - std::string cmdline = fmt::format("{0} {1} > {1}.txt", NCDUMP_BINARY, binary_file); + std::string cmdline = fmt::format("{0} {1} > {1}.txt", NCDUMP_EXECUTABLE, binary_file); system(cmdline.c_str()); END_HIDE_OUTPUT(); return fmt::format("{}.txt", binary_file); @@ -96,7 +96,7 @@ TEST_F(DumpNetCDFTest, run0_plain) generate_dump(dump_file, fields, "", 0); ASSERT_FILE_EXISTS(dump_file); - if (NCDUMP_BINARY) { + if (NCDUMP_EXECUTABLE) { auto converted_file = convert_binary_to_text(dump_file); auto lines = read_lines(converted_file); auto header = utils::split_words(lines[0]); @@ -246,7 +246,7 @@ TEST_F(DumpNetCDFTest, run0_mpi) generate_dump(dump_file, fields, "", 0); ASSERT_FILE_EXISTS(dump_file); - if (NCDUMP_BINARY) { + if (NCDUMP_EXECUTABLE) { auto converted_file = convert_binary_to_text(dump_file); auto lines = read_lines(converted_file); auto header = utils::split_words(lines[0]); @@ -402,7 +402,7 @@ int main(int argc, char **argv) } } - NCDUMP_BINARY = getenv("NCDUMP_BINARY"); + NCDUMP_EXECUTABLE = getenv("NCDUMP_EXECUTABLE"); if ((argc > 1) && (strcmp(argv[1], "-v") == 0)) verbose = true; diff --git a/unittest/formats/test_dump_xyz_compressed.cpp b/unittest/formats/test_dump_xyz_compressed.cpp index a851129c6c..7c5b816639 100644 --- a/unittest/formats/test_dump_xyz_compressed.cpp +++ b/unittest/formats/test_dump_xyz_compressed.cpp @@ -29,7 +29,7 @@ public: TEST_F(DumpXYZCompressTest, compressed_run0) { - if (!COMPRESS_BINARY) GTEST_SKIP(); + if (!COMPRESS_EXECUTABLE) GTEST_SKIP(); auto base_name = "run*.melt.xyz"; auto base_name_0 = "run0.melt.xyz"; @@ -61,7 +61,7 @@ TEST_F(DumpXYZCompressTest, compressed_run0) TEST_F(DumpXYZCompressTest, compressed_no_buffer_run0) { - if (!COMPRESS_BINARY) GTEST_SKIP(); + if (!COMPRESS_EXECUTABLE) GTEST_SKIP(); auto base_name = "no_buffer_run*.melt.xyz"; auto base_name_0 = "no_buffer_run0.melt.xyz"; @@ -93,7 +93,7 @@ TEST_F(DumpXYZCompressTest, compressed_no_buffer_run0) TEST_F(DumpXYZCompressTest, compressed_multi_file_run1) { - if (!COMPRESS_BINARY) GTEST_SKIP(); + if (!COMPRESS_EXECUTABLE) GTEST_SKIP(); auto base_name = "multi_file_run1_*.melt.xyz"; auto base_name_0 = "multi_file_run1_0.melt.xyz"; @@ -133,7 +133,7 @@ TEST_F(DumpXYZCompressTest, compressed_multi_file_run1) TEST_F(DumpXYZCompressTest, compressed_multi_file_with_pad_run1) { - if (!COMPRESS_BINARY) GTEST_SKIP(); + if (!COMPRESS_EXECUTABLE) GTEST_SKIP(); auto base_name = "multi_file_pad_run1_*.melt.xyz"; auto base_name_0 = "multi_file_pad_run1_000.melt.xyz"; @@ -174,7 +174,7 @@ TEST_F(DumpXYZCompressTest, compressed_multi_file_with_pad_run1) TEST_F(DumpXYZCompressTest, compressed_multi_file_with_maxfiles_run1) { - if (!COMPRESS_BINARY) GTEST_SKIP(); + if (!COMPRESS_EXECUTABLE) GTEST_SKIP(); auto base_name = "multi_file_maxfiles_run1_*.melt.xyz"; auto base_name_0 = "multi_file_maxfiles_run1_0.melt.xyz"; @@ -248,7 +248,7 @@ TEST_F(DumpXYZCompressTest, compressed_modify_multi_bad_param) TEST_F(DumpXYZCompressTest, compressed_modify_clevel_run0) { - if (!COMPRESS_BINARY) GTEST_SKIP(); + if (!COMPRESS_EXECUTABLE) GTEST_SKIP(); auto base_name = "modify_clevel_run0.melt.xyz"; auto text_file = text_dump_filename(base_name); From bead8190705df3993d331b8310ca9cfffd2552ab Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 23 May 2022 11:37:00 -0400 Subject: [PATCH 197/585] changes missing from the previous commit --- unittest/formats/compressed_dump_test.h | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/unittest/formats/compressed_dump_test.h b/unittest/formats/compressed_dump_test.h index 9b2dbc905b..d9803005e5 100644 --- a/unittest/formats/compressed_dump_test.h +++ b/unittest/formats/compressed_dump_test.h @@ -19,7 +19,7 @@ extern const char *COMPRESS_SUFFIX; extern const char *COMPRESS_EXTENSION; -extern char *COMPRESS_BINARY; +extern char *COMPRESS_EXECUTABLE; class CompressedDumpTest : public MeltTest { protected: @@ -102,7 +102,7 @@ public: BEGIN_HIDE_OUTPUT(); std::string converted_file = compressed_file.substr(0, compressed_file.find_last_of('.')); std::string cmdline = - fmt::format("{} -d -c {} > {}", COMPRESS_BINARY, compressed_file, converted_file); + fmt::format("{} -d -c {} > {}", COMPRESS_EXECUTABLE, compressed_file, converted_file); system(cmdline.c_str()); END_HIDE_OUTPUT(); return converted_file; From 3662d998ee19ba7fa133cc99ed6084ef67ada651 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 23 May 2022 11:53:58 -0400 Subject: [PATCH 198/585] fix typo + cut-n-paste error --- cmake/CMakeSettings.json | 10 +++++----- 1 file changed, 5 insertions(+), 5 deletions(-) diff --git a/cmake/CMakeSettings.json b/cmake/CMakeSettings.json index 6d4894f5c2..c139114c0b 100644 --- a/cmake/CMakeSettings.json +++ b/cmake/CMakeSettings.json @@ -144,7 +144,7 @@ "cmakeCommandArgs": "-C ${workspaceRoot}\\cmake\\presets\\windows-intel-llvm.cmake -C ${workspaceRoot}\\cmake\\presets\\windows.cmake", "variables": [ { - "name": "PKG_ELECTRON", + "name": "PKG_ELECTRODE", "value": "True", "type": "BOOL" }, @@ -187,7 +187,7 @@ "inheritEnvironments": [], "variables": [ { - "name": "PKG_ELECTRON", + "name": "PKG_ELECTRODE", "value": "True", "type": "BOOL" }, @@ -230,7 +230,7 @@ "inheritEnvironments": [], "variables": [ { - "name": "PKG_ELECTRON", + "name": "PKG_ELECTRODE", "value": "True", "type": "BOOL" }, @@ -273,7 +273,7 @@ "inheritEnvironments": [], "variables": [ { - "name": "PKG_ELECTRON", + "name": "PKG_ELECTRODE", "value": "True", "type": "BOOL" }, @@ -305,4 +305,4 @@ ] } ] -} \ No newline at end of file +} From ef80bb194a6aa1c3c41a06f0bf0c4a87c93a6bc8 Mon Sep 17 00:00:00 2001 From: Ravishankar Sundararaman Date: Mon, 23 May 2022 17:28:32 -0400 Subject: [PATCH 199/585] Fixed TIP4P handling in PPPM slab correction. Overridded the slabcorr() function to handle the charge being on the TIP4P "M" site in the dipole calculation (and corresponding force correction). This is important for any long-range electrostatics in aqueous interfaces with the TIP4P model. --- src/KSPACE/pppm_disp.h | 2 +- src/KSPACE/pppm_disp_tip4p.cpp | 79 +++++++++++++++++++++++++++++++++ src/KSPACE/pppm_disp_tip4p.h | 1 + src/KSPACE/pppm_tip4p.cpp | 80 ++++++++++++++++++++++++++++++++++ src/KSPACE/pppm_tip4p.h | 1 + 5 files changed, 162 insertions(+), 1 deletion(-) diff --git a/src/KSPACE/pppm_disp.h b/src/KSPACE/pppm_disp.h index 87265bee2f..1f254e772d 100644 --- a/src/KSPACE/pppm_disp.h +++ b/src/KSPACE/pppm_disp.h @@ -320,7 +320,7 @@ class PPPMDisp : public KSpace { void compute_drho1d(const FFT_SCALAR &, const FFT_SCALAR &, const FFT_SCALAR &, int, FFT_SCALAR **, FFT_SCALAR **); void compute_rho_coeff(FFT_SCALAR **, FFT_SCALAR **, int); - void slabcorr(int); + virtual void slabcorr(int); // grid communication diff --git a/src/KSPACE/pppm_disp_tip4p.cpp b/src/KSPACE/pppm_disp_tip4p.cpp index 902b512bc3..9ebc32ad05 100644 --- a/src/KSPACE/pppm_disp_tip4p.cpp +++ b/src/KSPACE/pppm_disp_tip4p.cpp @@ -486,6 +486,85 @@ void PPPMDispTIP4P::fieldforce_c_peratom() } } +/* ---------------------------------------------------------------------- + Fix handling of TIP4P dipole compared to PPPMDisp::slabcorr +------------------------------------------------------------------------- */ + +#define SMALL 0.00001 + +void PPPMDispTIP4P::slabcorr(int /*eflag*/) +{ + // compute local contribution to global dipole moment + + double *q = atom->q; + double **x = atom->x; + double zprd = domain->zprd; + int nlocal = atom->nlocal; + int *type = atom->type; + double *xi, xM[3]; int iH1, iH2; //for TIP4P virtual site + + // sum local contributions to get global dipole moment + double dipole = 0.0; + for (int i = 0; i < nlocal; i++) { + if (type[i] == typeO) { + find_M(i,iH1,iH2,xM); + xi = xM; + } else xi = x[i]; + dipole += q[i]*xi[2]; + } + + double dipole_all; + MPI_Allreduce(&dipole,&dipole_all,1,MPI_DOUBLE,MPI_SUM,world); + + // need to make non-neutral systems and/or + // per-atom energy translationally invariant + + double dipole_r2 = 0.0; + if (eflag_atom || fabs(qsum) > SMALL) { + for (int i = 0; i < nlocal; i++) + dipole_r2 += q[i]*x[i][2]*x[i][2]; + + // sum local contributions + + double tmp; + MPI_Allreduce(&dipole_r2,&tmp,1,MPI_DOUBLE,MPI_SUM,world); + dipole_r2 = tmp; + } + + // compute corrections + + const double e_slabcorr = MY_2PI*(dipole_all*dipole_all - + qsum*dipole_r2 - qsum*qsum*zprd*zprd/12.0)/volume; + const double qscale = force->qqrd2e * scale; + + if (eflag_global) energy_1 += qscale * e_slabcorr; + + // per-atom energy + + if (eflag_atom) { + double efact = qscale * MY_2PI/volume; + for (int i = 0; i < nlocal; i++) + eatom[i] += efact * q[i]*(x[i][2]*dipole_all - 0.5*(dipole_r2 + + qsum*x[i][2]*x[i][2]) - qsum*zprd*zprd/12.0); + } + + // add on force corrections + + double ffact = qscale * (-4.0*MY_PI/volume); + double **f = atom->f; + + for (int i = 0; i < nlocal; i++) { + double fzi_corr = ffact * q[i]*(dipole_all - qsum*x[i][2]); + if (type[i] == typeO) { + find_M(i,iH1,iH2,xM); + f[i][2] += fzi_corr*(1 - alpha); + f[iH1][2] += 0.5*alpha*fzi_corr; + f[iH2][2] += 0.5*alpha*fzi_corr; + } + else f[i][2] += fzi_corr; + } +} + /* ---------------------------------------------------------------------- find 2 H atoms bonded to O atom i compute position xM of fictitious charge site for O atom diff --git a/src/KSPACE/pppm_disp_tip4p.h b/src/KSPACE/pppm_disp_tip4p.h index a432a7eeeb..e9d5babe0f 100644 --- a/src/KSPACE/pppm_disp_tip4p.h +++ b/src/KSPACE/pppm_disp_tip4p.h @@ -37,6 +37,7 @@ class PPPMDispTIP4P : public PPPMDisp { void fieldforce_c_ik() override; void fieldforce_c_ad() override; void fieldforce_c_peratom() override; + void slabcorr(int) override; private: void find_M(int, int &, int &, double *); diff --git a/src/KSPACE/pppm_tip4p.cpp b/src/KSPACE/pppm_tip4p.cpp index 1cb7bf462f..e9d72bcefe 100644 --- a/src/KSPACE/pppm_tip4p.cpp +++ b/src/KSPACE/pppm_tip4p.cpp @@ -477,6 +477,86 @@ void PPPMTIP4P::fieldforce_peratom() } } + +/* ---------------------------------------------------------------------- + Fix handling of TIP4P dipole compared to PPPMDisp::slabcorr +------------------------------------------------------------------------- */ + +#define SMALL 0.00001 + +void PPPMTIP4P::slabcorr() +{ + // compute local contribution to global dipole moment + + double *q = atom->q; + double **x = atom->x; + double zprd = domain->zprd; + int nlocal = atom->nlocal; + int *type = atom->type; + double *xi, xM[3]; int iH1, iH2; //for TIP4P virtual site + + // sum local contributions to get global dipole moment + double dipole = 0.0; + for (int i = 0; i < nlocal; i++) { + if (type[i] == typeO) { + find_M(i,iH1,iH2,xM); + xi = xM; + } else xi = x[i]; + dipole += q[i]*xi[2]; + } + + double dipole_all; + MPI_Allreduce(&dipole,&dipole_all,1,MPI_DOUBLE,MPI_SUM,world); + + // need to make non-neutral systems and/or + // per-atom energy translationally invariant + + double dipole_r2 = 0.0; + if (eflag_atom || fabs(qsum) > SMALL) { + for (int i = 0; i < nlocal; i++) + dipole_r2 += q[i]*x[i][2]*x[i][2]; + + // sum local contributions + + double tmp; + MPI_Allreduce(&dipole_r2,&tmp,1,MPI_DOUBLE,MPI_SUM,world); + dipole_r2 = tmp; + } + + // compute corrections + + const double e_slabcorr = MY_2PI*(dipole_all*dipole_all - + qsum*dipole_r2 - qsum*qsum*zprd*zprd/12.0)/volume; + const double qscale = force->qqrd2e * scale; + + if (eflag_global) energy_1 += qscale * e_slabcorr; + + // per-atom energy + + if (eflag_atom) { + double efact = qscale * MY_2PI/volume; + for (int i = 0; i < nlocal; i++) + eatom[i] += efact * q[i]*(x[i][2]*dipole_all - 0.5*(dipole_r2 + + qsum*x[i][2]*x[i][2]) - qsum*zprd*zprd/12.0); + } + + // add on force corrections + + double ffact = qscale * (-4.0*MY_PI/volume); + double **f = atom->f; + + for (int i = 0; i < nlocal; i++) { + double fzi_corr = ffact * q[i]*(dipole_all - qsum*x[i][2]); + if (type[i] == typeO) { + find_M(i,iH1,iH2,xM); + f[i][2] += fzi_corr*(1 - alpha); + f[iH1][2] += 0.5*alpha*fzi_corr; + f[iH2][2] += 0.5*alpha*fzi_corr; + } + else f[i][2] += fzi_corr; + } +} + /* ---------------------------------------------------------------------- find 2 H atoms bonded to O atom i compute position xM of fictitious charge site for O atom diff --git a/src/KSPACE/pppm_tip4p.h b/src/KSPACE/pppm_tip4p.h index cf63af0d81..0e6b2cc91b 100644 --- a/src/KSPACE/pppm_tip4p.h +++ b/src/KSPACE/pppm_tip4p.h @@ -35,6 +35,7 @@ class PPPMTIP4P : public PPPM { void fieldforce_ik() override; void fieldforce_ad() override; void fieldforce_peratom() override; + void slabcorr() override; private: void find_M(int, int &, int &, double *); From 43b57b8aa556ee4f644d1034005ddd83b23b670c Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 23 May 2022 20:14:10 -0400 Subject: [PATCH 200/585] update unit test reference data --- .../tests/kspace-pppm_tip4p_slab.yaml | 120 +++++++++--------- 1 file changed, 60 insertions(+), 60 deletions(-) diff --git a/unittest/force-styles/tests/kspace-pppm_tip4p_slab.yaml b/unittest/force-styles/tests/kspace-pppm_tip4p_slab.yaml index 51c5a45941..9b9806df5b 100644 --- a/unittest/force-styles/tests/kspace-pppm_tip4p_slab.yaml +++ b/unittest/force-styles/tests/kspace-pppm_tip4p_slab.yaml @@ -1,7 +1,7 @@ --- -lammps_version: 10 Feb 2021 +lammps_version: 4 May 2022 tags: slow -date_generated: Fri Feb 26 23:09:34 2021 +date_generated: Mon May 23 20:12:38 2022 epsilon: 5e-13 prerequisites: ! | atom full @@ -27,67 +27,67 @@ init_coul: 0 init_stress: ! |2- 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 init_forces: ! |2 - 1 -5.1875059319876482e-01 5.1660852898514097e-02 -5.7568746684221916e-01 - 2 2.1689992534273889e-01 -2.6058788219741147e-01 4.1798750467672274e-01 - 3 -3.2123603964927645e-02 -8.8740124548059782e-03 -1.3836110655816162e-02 - 4 1.5801256389492813e-01 2.1126659375654909e-02 7.8030101326860571e-02 - 5 1.4630529362834138e-01 7.0541031372980123e-02 1.0367534136208822e-01 - 6 4.5271336509733173e-01 4.3434073283904712e-01 1.9672609182540585e-01 - 7 -2.5202832073509374e-01 -4.0972860647817611e-01 -5.1025448731009770e-01 - 8 -2.7733728801934087e-03 -6.6285305944413486e-01 -4.2259182161309783e-01 - 9 8.7284510947996261e-02 3.4644067741232221e-01 5.2649415280028289e-01 - 10 -7.0358238250045405e-02 1.2324438068757468e-01 9.7430764543568638e-02 - 11 -1.0611397012429427e-01 1.6778028608628817e-01 1.0243492986761592e-01 - 12 4.7522165036946828e-01 -4.7569230861934814e-01 -3.7620104501978141e-01 - 13 -1.5084555220571103e-01 1.3477824777242514e-01 1.5530580320476042e-01 - 14 -1.7331931611645846e-01 1.4489217533438961e-01 1.5187450400216165e-01 - 15 -1.4457383479163205e-01 1.0191957555196750e-01 1.2647045003724980e-01 - 16 -4.6380086833284712e-01 5.1725747136642608e-01 1.3944164623658954e+00 - 17 2.5830539911922701e-01 -4.4001348824516739e-01 -1.6368568925682263e+00 - 18 7.1711828509507158e-01 1.5135594083235546e+00 -3.0000511375094279e+00 - 19 -2.6526242862377652e-01 -7.5615232036394919e-01 1.6174668711138471e+00 - 20 -3.6412116833354524e-01 -6.8003985707517800e-01 1.5219834320490606e+00 - 21 2.1913962201245335e-01 2.8436767546323427e-01 -1.5830999741451532e+00 - 22 -1.1342236771135741e-01 -2.1501547367331550e-02 8.1828468024256407e-01 - 23 -1.3904196539005109e-01 -1.8302644136991242e-01 7.6537752144201421e-01 - 24 9.9781913572244155e-02 9.7885535038983940e-01 -1.2668572125502537e+00 - 25 1.3435697022842072e-01 -3.4498868790162351e-01 6.9488200140438949e-01 - 26 -2.4062268840602163e-01 -6.1062269338471520e-01 5.8807795407966368e-01 - 27 -6.0379577180174060e-01 9.0922264678215248e-01 -1.6721200413729438e+00 - 28 4.2997465966368542e-01 -5.0965848067708741e-01 9.0674794598209418e-01 - 29 2.4583990189455251e-01 -4.3624778607752923e-01 7.9388967726077175e-01 + 1 -5.1875059319876493e-01 5.1660852898514124e-02 -5.3139324142026889e-01 + 2 2.1689992534273903e-01 -2.6058788219741147e-01 3.8877216450479823e-01 + 3 -3.2123603964927645e-02 -8.8740124548059712e-03 -1.1951249999562964e-02 + 4 1.5801256389492810e-01 2.1126659375654853e-02 6.9548228373721183e-02 + 5 1.4630529362834138e-01 7.0541031372980081e-02 9.5193468408948823e-02 + 6 4.5271336509733173e-01 4.3434073283904689e-01 1.4866214509094927e-01 + 7 -2.5202832073509379e-01 -4.0972860647817605e-01 -4.6219054057564113e-01 + 8 -2.7733728801934924e-03 -6.6285305944413497e-01 -3.7829759619114767e-01 + 9 8.7284510947996316e-02 3.4644067741232221e-01 4.9727881262835838e-01 + 10 -7.0358238250045405e-02 1.2324438068757469e-01 9.0833752246682456e-02 + 11 -1.0611397012429427e-01 1.6778028608628820e-01 9.3953056914476557e-02 + 12 4.7522165036946817e-01 -4.7569230861934830e-01 -3.5075542616036326e-01 + 13 -1.5084555220571100e-01 1.3477824777242520e-01 1.4682393025162105e-01 + 14 -1.7331931611645843e-01 1.4489217533438964e-01 1.4339263104902228e-01 + 15 -1.4457383479163199e-01 1.0191957555196751e-01 1.1798857708411041e-01 + 16 -4.6380086833284706e-01 5.1725747136642608e-01 1.3463525156314389e+00 + 17 2.5830539911922706e-01 -4.4001348824516717e-01 -1.5887929458337697e+00 + 18 7.1711828509507103e-01 1.5135594083235548e+00 -2.9202084401105424e+00 + 19 -2.6526242862377630e-01 -7.5615232036394919e-01 1.5775455224144039e+00 + 20 -3.6412116833354502e-01 -6.8003985707517844e-01 1.4820620833496179e+00 + 21 2.1913962201245299e-01 2.8436767546323433e-01 -1.3892564908575578e+00 + 22 -1.1342236771135721e-01 -2.1501547367331557e-02 7.2136293859876610e-01 + 23 -1.3904196539005081e-01 -1.8302644136991245e-01 6.6845577979821647e-01 + 24 9.9781913572244044e-02 9.7885535038983906e-01 -1.0730137292626583e+00 + 25 1.3435697022842086e-01 -3.4498868790162335e-01 5.9796025976059175e-01 + 26 -2.4062268840602169e-01 -6.1062269338471475e-01 4.9115621243586605e-01 + 27 -6.0379577180174060e-01 9.0922264678215248e-01 -1.4782765580853483e+00 + 28 4.2997465966368531e-01 -5.0965848067708730e-01 8.0982620433829633e-01 + 29 2.4583990189455257e-01 -4.3624778607752923e-01 6.9696793561697401e-01 run_vdwl: 0 run_coul: 0 run_stress: ! |2- 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 0.0000000000000000e+00 run_forces: ! |2 - 1 -5.1741021308022928e-01 5.2164463970109785e-02 -5.7035795586691229e-01 - 2 2.1552845355081662e-01 -2.6145885390966006e-01 4.1455932829319120e-01 - 3 -3.2103136898117973e-02 -8.8506517835662529e-03 -1.3601661681107857e-02 - 4 1.5813149106431929e-01 2.0998590621170252e-02 7.7085061898295948e-02 - 5 1.4611782148177443e-01 7.0495101424978557e-02 1.0262211863021993e-01 - 6 4.5237682723361744e-01 4.3384953789975256e-01 1.9026464391810138e-01 - 7 -2.5220238048340610e-01 -4.1025291093818367e-01 -5.0478860778438306e-01 - 8 -1.8080584227147985e-03 -6.6262062885438788e-01 -4.1641859631215317e-01 - 9 8.6463014670901714e-02 3.4599477171923032e-01 5.2262452042463015e-01 - 10 -7.0489736534953079e-02 1.2334020200473024e-01 9.6566992716111827e-02 - 11 -1.0626441695286094e-01 1.6812163421601856e-01 1.0149591994495212e-01 - 12 4.7577991930135149e-01 -4.7567916757872036e-01 -3.7271573985070183e-01 - 13 -1.5102820761813157e-01 1.3482444566331483e-01 1.5423678933941967e-01 - 14 -1.7348673211954843e-01 1.4502141845434144e-01 1.5087187633492033e-01 - 15 -1.4462875081155377e-01 1.0177069356565076e-01 1.2517182091704590e-01 - 16 -4.6460162929294996e-01 5.1779385845248271e-01 1.3893654572043623e+00 - 17 2.5891442131187525e-01 -4.3950548671559936e-01 -1.6317550757697421e+00 - 18 7.2168431617151652e-01 1.5193451885286362e+00 -2.9893884981487782e+00 - 19 -2.6652798165736163e-01 -7.5811338734451528e-01 1.6128149463359120e+00 - 20 -3.6685702835539502e-01 -6.8322050954334113e-01 1.5165955023073157e+00 - 21 2.1951624771560643e-01 2.7908195130062186e-01 -1.5761953363577819e+00 - 22 -1.1336951380799791e-01 -1.8808477419676436e-02 8.1504600690354212e-01 - 23 -1.3925079650238253e-01 -1.8099002366078934e-01 7.6197026590425576e-01 - 24 1.0040861588721736e-01 9.7605298874640822e-01 -1.2616161159601158e+00 - 25 1.3326916759186308e-01 -3.4383632694371846e-01 6.9190323110048380e-01 - 26 -2.4021815268192853e-01 -6.0890409178886584e-01 5.8556538656853796e-01 - 27 -6.0409904237121848e-01 9.0912495784502378e-01 -1.6654694276801689e+00 - 28 4.3013936095125799e-01 -5.0934391123833689e-01 9.0325113244229294e-01 - 29 2.4601612065863304e-01 -4.3639537669310857e-01 7.9029601422825357e-01 + 1 -5.1741014216891323e-01 5.2164635296042393e-02 -5.2623836978475858e-01 + 2 2.1552846412199758e-01 -2.6145894539516673e-01 3.8545898349593888e-01 + 3 -3.2103138095670579e-02 -8.8506538753520981e-03 -1.1724235859914865e-02 + 4 1.5813145650026225e-01 2.0998621233542170e-02 6.8636593918036282e-02 + 5 1.4611784388196503e-01 7.0495096056163456e-02 9.4173752375773245e-02 + 6 4.5237719221599776e-01 4.3384962277065459e-01 1.4239025998317195e-01 + 7 -2.5220268493187059e-01 -4.1025301686518484e-01 -4.5691379591079689e-01 + 8 -1.8087303830687639e-03 -6.6262053829478962e-01 -3.7229928601228018e-01 + 9 8.6463301781221830e-02 3.4599465684255803e-01 4.9352454715915695e-01 + 10 -7.0489594513774040e-02 1.2334016665695119e-01 8.9996005394677253e-02 + 11 -1.0626421813039562e-01 1.6812158323291176e-01 9.3047478449378010e-02 + 12 4.7577947092697664e-01 -4.7567891996498934e-01 -3.4737046113988318e-01 + 13 -1.5102808666764547e-01 1.3482433032858601e-01 1.4578835246021055e-01 + 14 -1.7348659325588509e-01 1.4502136217343140e-01 1.4242345028236647e-01 + 15 -1.4462864359019598e-01 1.0177061950990737e-01 1.1672337003180658e-01 + 16 -4.6460067645864556e-01 5.1779370227303589e-01 1.3414908637759566e+00 + 17 2.5891386126470772e-01 -4.3950547582143235e-01 -1.5838807201814791e+00 + 18 7.2168370323432252e-01 1.5193447526996697e+00 -2.9098598385970016e+00 + 19 -2.6652787885830853e-01 -7.5811315791679745e-01 1.5730504781450976e+00 + 20 -3.6685665590502275e-01 -6.8322021768929220e-01 1.4768311717846097e+00 + 21 2.1951586762660091e-01 2.7908220235205461e-01 -1.3830824926773011e+00 + 22 -1.1336938042579009e-01 -1.8808601624035179e-02 7.1848935671661196e-01 + 23 -1.3925069633951992e-01 -1.8099007738613887e-01 6.6541382825713724e-01 + 24 1.0040887040966230e-01 9.7605345725512060e-01 -1.0685029118802341e+00 + 25 1.3326911366323715e-01 -3.4383656089990644e-01 5.9534683106490160e-01 + 26 -2.4021835151581941e-01 -6.0890428532016694e-01 4.8900886112265285e-01 + 27 -6.0409926106451306e-01 9.0912468504667421e-01 -1.4723570251596647e+00 + 28 4.3013929998720690e-01 -5.0934380660262080e-01 8.0669499930969779e-01 + 29 2.4601628669087905e-01 -4.3639523607143099e-01 6.9373995347613393e-01 ... From b66702c285fc16e04bb3dff558d8d64921c9400c Mon Sep 17 00:00:00 2001 From: =?UTF-8?q?Eugen=20Ro=C5=BEi=C4=87?= Date: Tue, 24 May 2022 11:37:44 +0200 Subject: [PATCH 201/585] Added verbose class option + removed empty output lines --- python/lammps/pylammps.py | 9 +++++---- 1 file changed, 5 insertions(+), 4 deletions(-) diff --git a/python/lammps/pylammps.py b/python/lammps/pylammps.py index cdb6620c27..1a64adb6ed 100644 --- a/python/lammps/pylammps.py +++ b/python/lammps/pylammps.py @@ -457,8 +457,9 @@ class PyLammps(object): :vartype run: list """ - def __init__(self, name="", cmdargs=None, ptr=None, comm=None): + def __init__(self, name="", cmdargs=None, ptr=None, comm=None, verbose=False): self.has_echo = False + self.verbose = verbose if cmdargs: if '-echo' in cmdargs: @@ -869,8 +870,8 @@ class PyLammps(object): if comm: output = self.lmp.comm.bcast(output, root=0) - if 'verbose' in kwargs and kwargs['verbose']: - print(output) + if self.verbose or ('verbose' in kwargs and kwargs['verbose']): + print(output, end = '') lines = output.splitlines() @@ -984,4 +985,4 @@ class IPyLammps(PyLammps): :rtype: :py:class:`IPython.display.HTML` """ from IPython.display import HTML - return HTML("") + return HTML("") \ No newline at end of file From 1aaa9ca4ae0bbb64a269a31301f78b6e9709016e Mon Sep 17 00:00:00 2001 From: =?UTF-8?q?Eugen=20Ro=C5=BEi=C4=87?= Date: Tue, 24 May 2022 12:02:34 +0200 Subject: [PATCH 202/585] Added documentation for verbose option --- python/lammps/pylammps.py | 4 +++- 1 file changed, 3 insertions(+), 1 deletion(-) diff --git a/python/lammps/pylammps.py b/python/lammps/pylammps.py index 1a64adb6ed..1fe1f2452b 100644 --- a/python/lammps/pylammps.py +++ b/python/lammps/pylammps.py @@ -449,6 +449,8 @@ class PyLammps(object): :type ptr: pointer :param comm: MPI communicator (as provided by `mpi4py `_). ``None`` means use ``MPI_COMM_WORLD`` implicitly. :type comm: MPI_Comm + :param verbose: print all LAMMPS output to stdout + :type verbose: bool :ivar lmp: instance of original LAMMPS Python interface :vartype lmp: :py:class:`lammps` @@ -985,4 +987,4 @@ class IPyLammps(PyLammps): :rtype: :py:class:`IPython.display.HTML` """ from IPython.display import HTML - return HTML("") \ No newline at end of file + return HTML("") From 59e010343016b9eafcaf75d3f279fd2b34b9fbc5 Mon Sep 17 00:00:00 2001 From: Lenz Fiedler Date: Tue, 24 May 2022 17:00:41 +0200 Subject: [PATCH 203/585] Added EPSILON to subdomain check --- src/compute_grid_local.cpp | 18 +++++++++++++----- 1 file changed, 13 insertions(+), 5 deletions(-) diff --git a/src/compute_grid_local.cpp b/src/compute_grid_local.cpp index 66eb0c5db3..a6f3cf29ad 100644 --- a/src/compute_grid_local.cpp +++ b/src/compute_grid_local.cpp @@ -23,6 +23,10 @@ #include "error.h" #include "comm.h" +// For the subdomain test below; grid-points and subdomain boundaries +// sometimes differ by minimal amounts (in the order of 2e-17). +#define EPSILON 1.0e-10 + using namespace LAMMPS_NS; /* ---------------------------------------------------------------------- */ @@ -239,11 +243,15 @@ void ComputeGridLocal::assign_coords() grid2x(ix, iy, iz, xgrid); // ensure gridpoint is not strictly outside subdomain - - if (xgrid[0] < sublo[0] || xgrid[0] > subhi[0] || - xgrid[1] < sublo[1] || xgrid[1] > subhi[1] || - xgrid[2] < sublo[2] || xgrid[2] > subhi[2]) - error->one(FLERR,"Invalid gridpoint position in compute grid/local"); + // There have been some problem with a gridpoint being something like 2e-17 outside of the subdomain, + // thus the EPISLON check. + if ((sublo[0]-xgrid[0]) > EPSILON || (xgrid[0]-subhi[0]) > EPSILON || + (sublo[1]-xgrid[1]) > EPSILON || (xgrid[1]-subhi[1]) > EPSILON || + (sublo[2]-xgrid[2]) > EPSILON || (xgrid[2]-subhi[2]) > EPSILON) + { + error->one(FLERR,"Invalid gridpoint position in compute grid/local"); + } + // convert lamda to x, y, z, after sudomain check From 43048811ddc69dd3b90789bdefc329d56be4e693 Mon Sep 17 00:00:00 2001 From: rohskopf Date: Tue, 24 May 2022 15:33:40 -0600 Subject: [PATCH 204/585] Build dbidrj array. --- examples/snap/compute.snap.dat | 59 +++++++ examples/snap/in.snap.compute | 6 +- python/lammps/mliap/__init__.py | 3 +- src/ML-SNAP/compute_snap.cpp | 271 ++++++++++++++++++++++++++++++-- src/ML-SNAP/compute_snap.h | 11 +- src/ML-SNAP/sna.cpp | 5 +- src/fix_move.cpp | 247 ++++++++++++++++++++++++++++- src/fix_move.h | 55 +++++++ 8 files changed, 628 insertions(+), 29 deletions(-) create mode 100644 examples/snap/compute.snap.dat diff --git a/examples/snap/compute.snap.dat b/examples/snap/compute.snap.dat new file mode 100644 index 0000000000..60aa40fdd6 --- /dev/null +++ b/examples/snap/compute.snap.dat @@ -0,0 +1,59 @@ +# Time-averaged data for fix snap +# TimeStep Number-of-rows +# Row c_snap[1] c_snap[2] c_snap[3] c_snap[4] c_snap[5] c_snap[6] c_snap[7] c_snap[8] c_snap[9] c_snap[10] c_snap[11] +0 55 +1 0 0 0 0 0 3.12659e+06 1.91282e+06 1.01756e+06 1.18149e+06 419003 2775.75 +2 0 0 0 0 0 0 -2617.97 -11804.8 -32003.5 -14156.5 -126.705 +3 0 0 0 0 0 0 -2414.16 -4239.67 -6275.15 -3852.23 -118.927 +4 0 0 0 0 0 0 2529.98 3883.7 6245.75 2522.89 103.66 +5 0 0 0 0 0 0 411.847 604.579 57.0959 1095.67 -188.806 +6 0 0 0 0 0 0 1541.86 4697.43 11841.7 5519.43 275.079 +7 0 0 0 0 0 0 -2870.68 -1447.5 4412.24 1032.92 -63.9586 +8 0 0 0 0 0 0 1193.62 7012.92 20475.9 9007.1 230.377 +9 0 0 0 0 0 0 4848.36 11241.9 22593.7 11630.3 42.8991 +10 0 0 0 0 0 0 -1770.07 -2679.25 -3788.5 -2555.62 -135.264 +11 0 0 0 0 0 0 -4969.62 -8016.32 -11201.8 -7220.33 -85.5022 +12 0 0 0 0 0 0 1641.76 3596.16 7806.47 3219.57 40.8509 +13 0 0 0 0 0 0 325.571 4349.75 13049 5826.43 27.2534 +14 0 0 0 0 0 0 5920.17 5611.27 846.546 2245.23 83.7477 +15 0 0 0 0 0 0 -888.529 -848.965 -1874.49 -290.268 -68.0047 +16 0 0 0 0 0 0 -1916.74 67.9945 4784.3 2143.56 -39.6058 +17 0 0 0 0 0 0 -4098.57 -10375.2 -22007.6 -10355 -200.101 +18 0 0 0 0 0 0 -2284.58 -6551.33 -15184.8 -7117.19 -67.4731 +19 0 0 0 0 0 0 -2737.86 -632.669 6669.64 2094.01 52.5289 +20 0 0 0 0 0 0 -2329.4 -41.9068 7566.17 1913.97 100.188 +21 0 0 0 0 0 0 -444.112 -2754.7 -8428.65 -3849.65 -122.932 +22 0 0 0 0 0 0 -70.5051 111.212 854.264 255.733 65.2259 +23 0 0 0 0 0 0 3554.61 12874.2 31397 14566.8 47.5973 +24 0 0 0 0 0 0 1865.24 2108.07 1180.27 1465.26 91.3443 +25 0 0 0 0 0 0 -889.973 2561.32 11256.4 4537.35 77.4022 +26 0 0 0 0 0 0 3550.36 106.913 -9710.14 -2944.98 144.241 +27 0 0 0 0 0 0 -4712.47 -8838.63 -14464.9 -8091.56 -224.069 +28 0 0 0 0 0 0 -2024.94 -4432.38 -9505.05 -4018.8 -207.602 +29 0 0 0 0 0 0 2379.69 4724.47 7670.76 5006.86 -23.6309 +30 0 0 0 0 0 0 376.992 1771.26 5976.85 2024.35 134.961 +31 0 0 0 0 0 0 1237.27 -1519.65 -9085.33 -3530.88 -43.4288 +32 0 0 0 0 0 0 583.161 6064.47 18404.5 7643.32 243.05 +33 0 0 0 0 0 0 -2538.86 -2021.15 691.987 -389.262 -141.239 +34 0 0 0 0 0 0 2885.38 5612.51 9715.93 5772.93 193.908 +35 0 0 0 0 0 0 -6048.23 -11209.3 -18774.1 -10567.4 -252.412 +36 0 0 0 0 0 0 -1418.32 -3619.88 -5764.64 -4231.84 203.031 +37 0 0 0 0 0 0 3007.44 1474.23 -3713.21 -994.284 140.462 +38 0 0 0 0 0 0 4888.42 4654.63 805.35 2190.37 43.3575 +39 0 0 0 0 0 0 969.58 3277.56 6218.65 3924.82 -58.9942 +40 0 0 0 0 0 0 2987.73 4234.51 5529.54 3085.54 43.2781 +41 0 0 0 0 0 0 810.067 -1872.94 -8730.18 -3125.43 -210.33 +42 0 0 0 0 0 0 2844.79 2986.48 1115.95 1588.01 123.161 +43 0 0 0 0 0 0 134.538 -4097.82 -14380.1 -6204.27 -19.7911 +44 0 0 0 0 0 0 -2999.2 -2447.09 1548.16 -1098.43 162.086 +45 0 0 0 0 0 0 -2288.5 -5930.54 -12773.2 -6503.71 -200.232 +46 0 0 0 0 0 0 -2625.62 -6290.98 -12970.9 -6562.73 -182.126 +47 0 0 0 0 0 0 -228.949 4114.07 13655.9 5798.77 32.8425 +48 0 0 0 0 0 0 2900.97 5126.05 7340.27 4953.94 90.5452 +49 0 0 0 0 0 0 1798.49 -1194.98 -9074.02 -3404.76 -11.9431 +50 0 0 0 0 0 0 -3.09692e+06 -3.518e+06 -4.33318e+06 -2.30338e+06 1.32116e+08 +51 0 0 0 0 0 0 -3.10721e+06 -3.53165e+06 -4.34977e+06 -2.31581e+06 1.28785e+08 +52 0 0 0 0 0 0 -3.10871e+06 -3.53788e+06 -4.36295e+06 -2.32103e+06 1.4248e+08 +53 0 0 0 0 0 0 3585.35 6805.98 11450.9 6458.62 914589 +54 0 0 0 0 0 0 -6674.27 -11551.6 -17884.1 -10474.7 -2.08251e+06 +55 0 0 0 0 0 0 -11913.9 -22733.1 -38858.2 -21261 -7.73337e+06 diff --git a/examples/snap/in.snap.compute b/examples/snap/in.snap.compute index b0c7314882..005ba8b1a3 100644 --- a/examples/snap/in.snap.compute +++ b/examples/snap/in.snap.compute @@ -3,7 +3,7 @@ # initialize simulation variable nsteps index 0 -variable nrep equal 1 +variable nrep equal 2 variable a equal 2.0 units metal @@ -81,7 +81,7 @@ thermo 100 # test output: 1: total potential energy # 2: xy component of stress tensor -# 3: Sum(B_{000}^i, all i of type 2) +# 3: Sum(B_{000}^i, all i of type 2) # 4: xz component of Sum(Sum(r_j*dB_{222}^i/dR[j]), all i of type 2), all j) # 5: y component of -Sum(d(B_{222}^i)/dR[2]), all i of type 2) # @@ -89,7 +89,7 @@ thermo 100 thermo_style custom & pe pxy c_bsum2[1] c_vbsum[55] v_db_2_25 & - c_snap[1][11] c_snap[13][11] c_snap[1][6] c_snap[12][10] c_snap[6][10] + c_snap[1][11] c_snap[13][11] c_snap[1][6] c_snap[12][10] c_snap[6][10] thermo_modify norm no # dump mydump_db all custom 1000 dump_db id c_db[*] diff --git a/python/lammps/mliap/__init__.py b/python/lammps/mliap/__init__.py index 57fe97d803..bbb5bb51a5 100644 --- a/python/lammps/mliap/__init__.py +++ b/python/lammps/mliap/__init__.py @@ -4,7 +4,8 @@ # try to improperly start up a new interpreter. import sysconfig import ctypes -library = sysconfig.get_config_vars('INSTSONAME')[0] +#library = sysconfig.get_config_vars('INSTSONAME')[0] +library="/usr/local/Cellar/python@3.10/3.10.2/Frameworks/Python.framework/Versions/3.10/Python" try: pylib = ctypes.CDLL(library) except OSError as e: diff --git a/src/ML-SNAP/compute_snap.cpp b/src/ML-SNAP/compute_snap.cpp index 83f56e338c..70464420c2 100644 --- a/src/ML-SNAP/compute_snap.cpp +++ b/src/ML-SNAP/compute_snap.cpp @@ -56,6 +56,7 @@ ComputeSnap::ComputeSnap(LAMMPS *lmp, int narg, char **arg) : bzeroflag = 1; quadraticflag = 0; bikflag = 0; + dbirjflag = 0; chemflag = 0; bnormflag = 0; wselfallflag = 0; @@ -81,6 +82,7 @@ ComputeSnap::ComputeSnap(LAMMPS *lmp, int narg, char **arg) : memory->create(cutsq,ntypes+1,ntypes+1,"snap:cutsq"); for (int i = 1; i <= ntypes; i++) { cut = 2.0*radelem[i]*rcutfac; + printf("cut: %f\n", cut); if (cut > cutmax) cutmax = cut; cutsq[i][i] = cut*cut; for (int j = i+1; j <= ntypes; j++) { @@ -147,6 +149,11 @@ ComputeSnap::ComputeSnap(LAMMPS *lmp, int narg, char **arg) : error->all(FLERR,"Illegal compute snap command"); bikflag = atoi(arg[iarg+1]); iarg += 2; + } else if (strcmp(arg[iarg],"dbirjflag") == 0) { + if (iarg+2 > narg) + error->all(FLERR,"Illegal compute snap command"); + dbirjflag = atoi(arg[iarg+1]); + iarg += 2; } else if (strcmp(arg[iarg],"switchinnerflag") == 0) { if (iarg+2 > narg) error->all(FLERR,"Illegal compute snap command"); @@ -194,7 +201,9 @@ ComputeSnap::ComputeSnap(LAMMPS *lmp, int narg, char **arg) : natoms = atom->natoms; bik_rows = 1; if (bikflag) bik_rows = natoms; - size_array_rows = bik_rows+ndims_force*natoms+ndims_virial; + //size_array_rows = bik_rows+ndims_force*natoms+ndims_virial; + dbirj_rows = ndims_force*natoms; + size_array_rows = bik_rows+dbirj_rows+ndims_virial; size_array_cols = nperdim*atom->ntypes+1; lastcol = size_array_cols-1; @@ -222,6 +231,14 @@ ComputeSnap::~ComputeSnap() memory->destroy(sinnerelem); memory->destroy(dinnerelem); } + + if (dbirjflag){ + printf("dbirj_rows: %d\n", dbirj_rows); + memory->destroy(dbirj); + memory->destroy(nneighs); + memory->destroy(neighsum); + memory->destroy(icounter); + } } /* ---------------------------------------------------------------------- */ @@ -231,8 +248,10 @@ void ComputeSnap::init() if (force->pair == nullptr) error->all(FLERR,"Compute snap requires a pair style be defined"); - if (cutmax > force->pair->cutforce) + if (cutmax > force->pair->cutforce){ + //printf("----- cutmax cutforce: %f %f\n", cutmax, force->pair->cutforce); error->all(FLERR,"Compute snap cutoff is longer than pairwise cutoff"); + } // need an occasional full neighbor list @@ -243,7 +262,7 @@ void ComputeSnap::init() snaptr->init(); // allocate memory for global array - + printf("----- dbirjflag: %d\n", dbirjflag); memory->create(snap,size_array_rows,size_array_cols, "snap:snap"); memory->create(snapall,size_array_rows,size_array_cols, @@ -283,6 +302,13 @@ void ComputeSnap::init_list(int /*id*/, NeighList *ptr) void ComputeSnap::compute_array() { + if (dbirjflag){ + printf("----- dbirjflag true.\n"); + get_dbirj_length(); + printf("----- got dbirj_length\n"); + } + printf("----- cutmax cutforce: %f %f\n", cutmax, force->pair->cutforce); + //else{ int ntotal = atom->nlocal + atom->nghost; invoked_array = update->ntimestep; @@ -295,22 +321,22 @@ void ComputeSnap::compute_array() memory->create(snap_peratom,nmax,size_peratom, "snap:snap_peratom"); } - // clear global array - - for (int irow = 0; irow < size_array_rows; irow++) - for (int icoeff = 0; icoeff < size_array_cols; icoeff++) + printf("size_array_rows: %d\n", size_array_rows); + for (int irow = 0; irow < size_array_rows; irow++){ + for (int icoeff = 0; icoeff < size_array_cols; icoeff++){ + //printf("%d %d\n", irow, icoeff); snap[irow][icoeff] = 0.0; + } + } // clear local peratom array - for (int i = 0; i < ntotal; i++) for (int icoeff = 0; icoeff < size_peratom; icoeff++) { snap_peratom[i][icoeff] = 0.0; } // invoke full neighbor list (will copy or build if necessary) - neighbor->build_one(list); const int inum = list->inum; @@ -324,11 +350,17 @@ void ComputeSnap::compute_array() double** const x = atom->x; const int* const mask = atom->mask; - + //printf("----- inum: %d\n", inum); + //printf("----- NEIGHMASK: %d\n", NEIGHMASK); + int ninside; + int numneigh_sum = 0; for (int ii = 0; ii < inum; ii++) { int irow = 0; if (bikflag) irow = atom->tag[ilist[ii] & NEIGHMASK]-1; + printf("----- ii, ilist, itag, irow: %d %d %d %d\n", ii, ilist[ii] & NEIGHMASK, atom->tag[ilist[ii]], irow); const int i = ilist[ii]; + //printf("----- ii, i: %d %d\n", ii, i); + //printf("----- mask[i] groupbit: %d %d\n", mask[i], groupbit); if (mask[i] & groupbit) { const double xtmp = x[i][0]; @@ -353,7 +385,13 @@ void ComputeSnap::compute_array() // typej = types of neighbors of I within cutoff // note Rij sign convention => dU/dRij = dU/dRj = -dU/dRi - int ninside = 0; + /* + This loop assigns quantities in snaptr. + snaptr is a SNA class instance, see sna.h + + */ + //int ninside = 0; + ninside=0; for (int jj = 0; jj < jnum; jj++) { int j = jlist[jj]; j &= NEIGHMASK; @@ -367,6 +405,7 @@ void ComputeSnap::compute_array() if (chemflag) jelem = map[jtype]; if (rsq < cutsq[itype][jtype]&&rsq>1e-20) { + //printf("cutsq: %f\n", cutsq[itype][jtype]); snaptr->rij[ninside][0] = delx; snaptr->rij[ninside][1] = dely; snaptr->rij[ninside][2] = delz; @@ -382,27 +421,94 @@ void ComputeSnap::compute_array() } } + /* + Now that we have assigned neighbor quantities with previous loop, we are ready to compute things. + Here we compute the wigner functions (U), Z is some other quantity, and bi is bispectrum. + */ snaptr->compute_ui(ninside, ielem); snaptr->compute_zi(); snaptr->compute_bi(ielem); + /* + Looks like this loop computes derivatives. + How does snaptr know what atom I we're dealing with? + I think it only needs neighbor info, and then it goes from there. + */ + //printf("----- Derivative loop - looping over neighbors j.\n"); + printf("----- ninside: %d\n", ninside); // numneighs of I within cutoff for (int jj = 0; jj < ninside; jj++) { + //printf("----- jj: %d\n", jj); const int j = snaptr->inside[jj]; + //printf("----- jj, j, jtag: %d %d %d\n", jj, j, atom->tag[j]); + //int dbirj_row_indx = 3*neighsum[i] + 3*jj ; // THIS IS WRONG, SEE NEXT LINE. + //int dbirj_row_indx = 3*neighsum[j] + 3*i_indx; // need to get i_indx. + // How to get i_indx? + /* + i_indx must start at zero and end at (nneighs[j]-1). + We can start a counter for each atom j. + Maybe this icounter can serve as an index for i as a neighbor of j. + icounter starts at zero and ends at (nneighs[j]-1). + */ + //icounter[atom->tag[j]-1] += 1; + int dbirj_row_indx = 3*neighsum[atom->tag[j]-1] + 3*icounter[atom->tag[j]-1] ; // THIS IS WRONG, SEE NEXT VAR. + printf("jtag, icounter, dbirj_row_indx: %d, %d, %d %d %d\n", atom->tag[j], icounter[atom->tag[j]-1], dbirj_row_indx+0, dbirj_row_indx+1, dbirj_row_indx+2); + icounter[atom->tag[j]-1] += 1; + /* + j is an atom index starting from 0. + Use atom->tag[j] to get the atom in the box (index starts at 1). + Need to make sure that the order of these ij pairs is the same when multiplying by dE/dD later. + */ + //printf("----- jj, j, jtag: %d %d %d\n", jj, j, atom->tag[j]); snaptr->compute_duidrj(jj); snaptr->compute_dbidrj(); // Accumulate dBi/dRi, -dBi/dRj + /* + snap_peratom[i] has type double * because each atom index has indices for descriptors. + */ double *snadi = snap_peratom[i]+typeoffset_local; double *snadj = snap_peratom[j]+typeoffset_local; - + //printf("----- ncoeff: %d\n", ncoeff); + //printf("snadi: %f %f %f %f %f\n", snadi[0], snadi[1], snadi[2], snadi[3], snadi[4]); + //printf("----- typeoffset_local: %d\n", typeoffset_local); + //printf("snadi: "); + //for (int s=0; s<(ncoeff*3); s++){ + // printf("%f ", snadi[s]); + //} + /* + printf("snadj: "); + for (int s=0; s<(ncoeff*3); s++){ + printf("%f ", snadj[s]); + } + */ + //printf("\n"); for (int icoeff = 0; icoeff < ncoeff; icoeff++) { + //printf("----- dblist[icoeff]: %f %f %f\n", snaptr->dblist[icoeff][0], snaptr->dblist[icoeff][1], snaptr->dblist[icoeff][2]); + /* + I think these are the descriptor derivatives. + Desriptor derivatives wrt atom i. + What exactly is being summed here? + This is a loop over descriptors or coeff k. + + */ snadi[icoeff] += snaptr->dblist[icoeff][0]; snadi[icoeff+yoffset] += snaptr->dblist[icoeff][1]; snadi[icoeff+zoffset] += snaptr->dblist[icoeff][2]; + /* + Descriptor derivatives wrt atom j + */ snadj[icoeff] -= snaptr->dblist[icoeff][0]; snadj[icoeff+yoffset] -= snaptr->dblist[icoeff][1]; snadj[icoeff+zoffset] -= snaptr->dblist[icoeff][2]; + + + if (dbirjflag){ + dbirj[dbirj_row_indx+0][icoeff] = snaptr->dblist[icoeff][0]; + dbirj[dbirj_row_indx+1][icoeff] = snaptr->dblist[icoeff][1]; + dbirj[dbirj_row_indx+2][icoeff] = snaptr->dblist[icoeff][2]; + } + } if (quadraticflag) { @@ -453,9 +559,11 @@ void ComputeSnap::compute_array() } } - } + } // for (int jj = 0; jj < ninside; jj++) + //printf("---- irow after jj loop: %d\n", irow); // Accumulate Bi + //printf("----- Accumulate Bi.\n"); // linear contributions @@ -476,18 +584,38 @@ void ComputeSnap::compute_array() } } } + + numneigh_sum += ninside; + } // for (int ii = 0; ii < inum; ii++) + + // Check icounter. + for (int ii = 0; ii < inum; ii++) { + const int i = ilist[ii]; + if (mask[i] & groupbit) { + printf("icounter[i]: %d\n", icounter[i]); + } } + //printf("----- Accumulate bispecturm force contributions to global array.\n"); // accumulate bispectrum force contributions to global array - + //printf("----- ntotal, nmax, natoms: %d %d %d\n", ntotal, nmax, atom->natoms); for (int itype = 0; itype < atom->ntypes; itype++) { const int typeoffset_local = ndims_peratom*nperdim*itype; const int typeoffset_global = nperdim*itype; + //printf("----- nperdim: %d\n", nperdim); + /*nperdim = ncoeff set previsouly*/ for (int icoeff = 0; icoeff < nperdim; icoeff++) { + //printf("----- icoeff: %d\n", icoeff); for (int i = 0; i < ntotal; i++) { double *snadi = snap_peratom[i]+typeoffset_local; int iglobal = atom->tag[i]; + if (icoeff==4){ + if ( (snadi[icoeff] != 0.0) || (snadi[icoeff+yoffset] != 0.0) || (snadi[icoeff+zoffset] != 0.0) ){ + //printf("%d %d %f %f %f\n", i, iglobal, snadi[icoeff], snadi[icoeff+yoffset], snadi[icoeff+zoffset]); + } + } int irow = 3*(iglobal-1)+bik_rows; + //printf("----- snadi[icoeff]: %f\n", snadi[icoeff]); snap[irow++][icoeff+typeoffset_global] += snadi[icoeff]; snap[irow++][icoeff+typeoffset_global] += snadi[icoeff+yoffset]; snap[irow][icoeff+typeoffset_global] += snadi[icoeff+zoffset]; @@ -495,13 +623,20 @@ void ComputeSnap::compute_array() } } + //printf("----- Accumulate forces to global array.\n"); + /* + These are the last columns. + */ // accumulate forces to global array for (int i = 0; i < atom->nlocal; i++) { int iglobal = atom->tag[i]; int irow = 3*(iglobal-1)+bik_rows; + //printf("---- irow: %d\n", irow); snap[irow++][lastcol] = atom->f[i][0]; + //printf("---- irow: %d\n", irow); snap[irow++][lastcol] = atom->f[i][1]; + //printf("---- irow: %d\n", irow); snap[irow][lastcol] = atom->f[i][2]; } @@ -531,6 +666,9 @@ void ComputeSnap::compute_array() snapall[irow++][lastcol] = c_virial->vector[4]; snapall[irow][lastcol] = c_virial->vector[3]; + //}// else + + printf("----- End of compute_array.\n"); } /* ---------------------------------------------------------------------- @@ -567,6 +705,111 @@ void ComputeSnap::dbdotr_compute() } } +/* ---------------------------------------------------------------------- + compute dbirj length +------------------------------------------------------------------------- */ + +void ComputeSnap::get_dbirj_length() +{ + // invoke full neighbor list (will copy or build if necessary) + neighbor->build_one(list); + //memory->destroy(snap); + //memory->destroy(snapall); + dbirj_rows = 0; + const int inum = list->inum; + const int* const ilist = list->ilist; + const int* const numneigh = list->numneigh; + int** const firstneigh = list->firstneigh; + int * const type = atom->type; + const int* const mask = atom->mask; + double** const x = atom->x; + //printf("----- inum: %d\n", inum); + memory->create(neighsum, inum, "snap:neighsum"); + memory->create(nneighs, inum, "snap:nneighs"); + memory->create(icounter, inum, "snap:icounter"); + for (int ii = 0; ii < inum; ii++) { + const int i = ilist[ii]; + if (mask[i] & groupbit) { + icounter[i]=0; + neighsum[i] = 0; + nneighs[i] = 0; + const double xtmp = x[i][0]; + const double ytmp = x[i][1]; + const double ztmp = x[i][2]; + const int itype = type[i]; + const int* const jlist = firstneigh[i]; + const int jnum = numneigh[i]; + //printf("----- jnum: %d\n", jnum); + int jnum_cutoff = 0; + for (int jj = 0; jj < jnum; jj++) { + int j = jlist[jj]; + j &= NEIGHMASK; + + const double delx = x[j][0] - xtmp; + const double dely = x[j][1] - ytmp; + const double delz = x[j][2] - ztmp; + const double rsq = delx*delx + dely*dely + delz*delz; + int jtype = type[j]; + + if (rsq < cutsq[itype][jtype]&&rsq>1e-20) { + dbirj_rows += 1; //jnum + 1; + jnum_cutoff += 1; + nneighs[i]+=1; + } + } + //printf("----- jnum_cutoff: %d\n", jnum_cutoff); + } + } + + dbirj_rows *= ndims_force; + + // Loop over all atoms again to calculate neighsum. + for (int ii = 0; ii < inum; ii++) { + const int i = ilist[ii]; + if (mask[i] & groupbit) { + //printf("nneighs[i]: %d\n", nneighs[i]); + //neighsum[i] = 0; + //printf("i nneighs[i]: %d %d\n", i, nneighs[i]); + if (i==0){ + neighsum[i]=0; + } + else{ + for (int jj=0; jj < ii; jj++){ + const int j = ilist[jj]; + if (mask[j] & groupbit) { + //printf(" j nneighs[j-1]: %d %d\n", j, nneighs[j]); + neighsum[i] += nneighs[j]; + } + } + } + } + //printf("%d\n", neighsum[i]); + } + + memory->create(dbirj, dbirj_rows, ncoeff, "snap:dbirj"); + // Set size array rows which now depends on dbirj_rows. + //size_array_rows = bik_rows+dbirj_rows+ndims_virial; + //printf("----- dbirj_rows: %d\n", dbirj_rows); + //printf("----- end of dbirj length.\n"); + /* + memory->create(snap,size_array_rows,size_array_cols, + "snap:snap"); + memory->create(snapall,size_array_rows,size_array_cols, + "snap:snapall"); + array = snapall; + */ +} + +/* ---------------------------------------------------------------------- + compute array length +------------------------------------------------------------------------- */ + +double ComputeSnap::compute_scalar() +{ + if (dbirjflag) get_dbirj_length(); + return size_array_rows; +} + /* ---------------------------------------------------------------------- memory usage ------------------------------------------------------------------------- */ diff --git a/src/ML-SNAP/compute_snap.h b/src/ML-SNAP/compute_snap.h index bc0670e2c7..d077b8f463 100644 --- a/src/ML-SNAP/compute_snap.h +++ b/src/ML-SNAP/compute_snap.h @@ -31,6 +31,7 @@ class ComputeSnap : public Compute { void init() override; void init_list(int, class NeighList *) override; void compute_array() override; + double compute_scalar() override; double memory_usage() override; private: @@ -52,13 +53,19 @@ class ComputeSnap : public Compute { class SNA *snaptr; double cutmax; int quadraticflag; - int bikflag; - int bik_rows; + //int bikflag; + //int bik_rows; + int bikflag, bik_rows, dbirjflag, dbirj_rows; + double **dbirj; + int *nneighs; // number of neighs inside the snap cutoff. + int *neighsum; + int *icounter; // counting atoms i for each j. Compute *c_pe; Compute *c_virial; void dbdotr_compute(); + void get_dbirj_length(); }; } // namespace LAMMPS_NS diff --git a/src/ML-SNAP/sna.cpp b/src/ML-SNAP/sna.cpp index 33937b9c45..d71eeaa7cb 100644 --- a/src/ML-SNAP/sna.cpp +++ b/src/ML-SNAP/sna.cpp @@ -776,6 +776,7 @@ void SNA::compute_dbidrj() int elem3 = elem_duarray; + //printf("----- idxb_max: %d\n", idxb_max); for (int jjb = 0; jjb < idxb_max; jjb++) { const int j1 = idxb[jjb].j1; const int j2 = idxb[jjb].j2; @@ -1334,6 +1335,9 @@ double SNA::memory_usage() void SNA::create_twojmax_arrays() { + + //printf("----- idxb_max: %d\n", idxb_max); + //printf("----- ntriples: %d\n", ntriples); int jdimpq = twojmax + 2; memory->create(rootpqarray, jdimpq, jdimpq, "sna:rootpqarray"); @@ -1595,4 +1599,3 @@ double SNA::compute_dsfac(double r, double rcut, double sinner, double dinner) return dsfac; } - diff --git a/src/fix_move.cpp b/src/fix_move.cpp index 37e8647671..7cf5567028 100644 --- a/src/fix_move.cpp +++ b/src/fix_move.cpp @@ -35,11 +35,16 @@ #include #include +#include +#include +#include +#include + using namespace LAMMPS_NS; using namespace FixConst; using namespace MathConst; -enum { LINEAR, WIGGLE, ROTATE, VARIABLE, TRANSROT }; +enum { LINEAR, WIGGLE, ROTATE, VARIABLE, TRANSROT, WIGGLE_EIGEN }; enum { EQUAL, ATOM }; #define INERTIA 0.2 // moment of inertia prefactor for ellipsoid @@ -187,7 +192,80 @@ FixMove::FixMove(LAMMPS *lmp, int narg, char **arg) : } else error->all(FLERR, "Illegal fix move command"); - } else + } + // Fix move wiggle_eigen + else if (strcmp(arg[3], "wiggle_eigen") == 0) { + int natoms = atom->natoms; + int nlocal = atom->nlocal; + printf("----- fix move wiggle_eigen initialize -----\n"); + printf("natoms: %d\n", natoms); + memory->create(emat,natoms*3,natoms*3,"move:emat"); + memory->create(freq,natoms*3,"move:freq"); + + // Read EMAT + std::ifstream readfile2; + for (int i = 0; i < natoms*3; i++) { + for (int j = 0; j < natoms*3; j++) { + emat[i][j] = 0.0; + } + } + readfile2.open("../EMAT"); + //readfile2.open("ev_real.txt"); + if (!readfile2.is_open()) { + //printf("ASDFASDF"); + printf("Unable to open ../EMAT\n"); + exit(1); + } + //printf("natoms: %d\n", natoms); + for (int i=0;i<3*natoms;i++){ + for (int j=0;j<3*natoms;j++){ + readfile2>>emat[i][j]; + } + } + + // Read FREQUENCIES + std::ifstream readfile3; + for (int i = 0; i < natoms*3; i++) { + freq[i]=0.0; + } + readfile3.open("FREQUENCIES"); + //readfile2.open("ev_real.txt"); + + if (!readfile3.is_open()) { + printf("Unable to open FREQUENCIES.\n"); + exit(1); + } + //printf("natoms: %d\n", natoms); + for (int i=0;i<3*natoms;i++){ + readfile3>>freq[i]; + } + + + if (narg < 8) error->all(FLERR, "Illegal fix move command"); + iarg = 8; + mstyle = WIGGLE_EIGEN; + if (strcmp(arg[4], "NULL") == 0) + axflag = 0; + else { + axflag = 1; + ax = utils::numeric(FLERR, arg[4], false, lmp); + } + if (strcmp(arg[5], "NULL") == 0) + ayflag = 0; + else { + ayflag = 1; + ay = utils::numeric(FLERR, arg[5], false, lmp); + } + if (strcmp(arg[6], "NULL") == 0) + azflag = 0; + else { + azflag = 1; + az = utils::numeric(FLERR, arg[6], false, lmp); + } + period = utils::numeric(FLERR, arg[7], false, lmp); + if (period <= 0.0) error->all(FLERR, "Illegal fix move command"); + } + else error->all(FLERR, "Illegal fix move command"); // optional args @@ -236,6 +314,10 @@ FixMove::FixMove(LAMMPS *lmp, int narg, char **arg) : if (axflag) ax *= xscale; if (ayflag) ay *= yscale; if (azflag) az *= zscale; + } else if (mstyle == WIGGLE_EIGEN) { + if (axflag) ax *= xscale; + if (ayflag) ay *= yscale; + if (azflag) az *= zscale; } else if (mstyle == ROTATE) { point[0] *= xscale; point[1] *= yscale; @@ -252,7 +334,7 @@ FixMove::FixMove(LAMMPS *lmp, int narg, char **arg) : // set omega_rotate from period - if ((mstyle == WIGGLE) || (mstyle == ROTATE) || (mstyle == TRANSROT)) + if ((mstyle == WIGGLE) || (mstyle == ROTATE) || (mstyle == TRANSROT) || (mstyle == WIGGLE_EIGEN)) omega_rotate = MY_2PI / period; // runit = unit vector along rotation axis @@ -295,10 +377,10 @@ FixMove::FixMove(LAMMPS *lmp, int narg, char **arg) : // AtomVec pointers to retrieve per-atom storage of extra quantities - avec_ellipsoid = dynamic_cast(atom->style_match("ellipsoid")); - avec_line = dynamic_cast(atom->style_match("line")); - avec_tri = dynamic_cast(atom->style_match("tri")); - avec_body = dynamic_cast(atom->style_match("body")); + avec_ellipsoid = dynamic_cast( atom->style_match("ellipsoid")); + avec_line = dynamic_cast( atom->style_match("line")); + avec_tri = dynamic_cast( atom->style_match("tri")); + avec_body = dynamic_cast( atom->style_match("body")); // xoriginal = initial unwrapped positions of atoms // toriginal = initial theta of lines @@ -380,6 +462,11 @@ FixMove::~FixMove() memory->destroy(displace); memory->destroy(velocity); + if (mstyle==WIGGLE_EIGEN){ + memory->destroy(emat); + memory->destroy(freq); + } + delete[] xvarstr; delete[] yvarstr; delete[] zvarstr; @@ -495,7 +582,7 @@ void FixMove::init() velocity = nullptr; if (utils::strmatch(update->integrate_style, "^respa")) - nlevels_respa = (dynamic_cast(update->integrate))->nlevels; + nlevels_respa = (dynamic_cast( update->integrate))->nlevels; } /* ---------------------------------------------------------------------- @@ -527,6 +614,7 @@ void FixMove::initial_integrate(int /*vflag*/) int *tri = atom->tri; int *body = atom->body; int *mask = atom->mask; + int *tag = atom->tag; int nlocal = atom->nlocal; @@ -652,6 +740,142 @@ void FixMove::initial_integrate(int /*vflag*/) // X = P + C + A cos(w*dt) + B sin(w*dt) // V = w R0 cross (A cos(w*dt) + B sin(w*dt)) +} else if (mstyle == WIGGLE_EIGEN) { + //printf("----- Wiggling!-----\n"); + int modeindx = 10; + //printf("%f %f\n", omega_rotate, MY_2PI*freq[modeindx]); + omega_rotate = MY_2PI*freq[modeindx]; + double arg = omega_rotate * delta; + double sine = sin(arg); + double cosine = cos(arg); + + //printf("arg: %f\n", arg); + for (int alpha=0; alpha<3; alpha++){ + for (int i=0; iremap_near(x[i], xold); + } + + } + + + } + + /* + for (int i=0; iremap_near(x[i], xold); + } + + } + */ + + /* + for (int i = 0; i < nlocal; i++) { + if (mask[i] & groupbit) { + xold[0] = x[i][0]; + xold[1] = x[i][1]; + xold[2] = x[i][2]; + + if (axflag) { + v[i][0] = ax * omega_rotate * cosine; + x[i][0] = xoriginal[i][0] + ax * sine; + } else if (rmass) { + dtfm = dtf / rmass[i]; + v[i][0] += dtfm * f[i][0]; + x[i][0] += dtv * v[i][0]; + } else { + dtfm = dtf / mass[type[i]]; + v[i][0] += dtfm * f[i][0]; + x[i][0] += dtv * v[i][0]; + } + + if (ayflag) { + v[i][1] = ay * omega_rotate * cosine; + x[i][1] = xoriginal[i][1] + ay * sine; + } else if (rmass) { + dtfm = dtf / rmass[i]; + v[i][1] += dtfm * f[i][1]; + x[i][1] += dtv * v[i][1]; + } else { + dtfm = dtf / mass[type[i]]; + v[i][1] += dtfm * f[i][1]; + x[i][1] += dtv * v[i][1]; + } + + if (azflag) { + v[i][2] = az * omega_rotate * cosine; + x[i][2] = xoriginal[i][2] + az * sine; + } else if (rmass) { + dtfm = dtf / rmass[i]; + v[i][2] += dtfm * f[i][2]; + x[i][2] += dtv * v[i][2]; + } else { + dtfm = dtf / mass[type[i]]; + v[i][2] += dtfm * f[i][2]; + x[i][2] += dtv * v[i][2]; + } + + domain->remap_near(x[i], xold); + } + } + */ + // for rotate by right-hand rule around omega: + // P = point = vector = point of rotation + // R = vector = axis of rotation + // w = omega of rotation (from period) + // X0 = xoriginal = initial coord of atom + // R0 = runit = unit vector for R + // D = X0 - P = vector from P to X0 + // C = (D dot R0) R0 = projection of atom coord onto R line + // A = D - C = vector from R line to X0 + // B = R0 cross A = vector perp to A in plane of rotation + // A,B define plane of circular rotation around R line + // X = P + C + A cos(w*dt) + B sin(w*dt) + // V = w R0 cross (A cos(w*dt) + B sin(w*dt)) + } else if (mstyle == ROTATE) { double arg = omega_rotate * delta; double cosine = cos(arg); @@ -1303,6 +1527,13 @@ void FixMove::set_arrays(int i) if (ayflag) xoriginal[i][1] -= ay * sine; if (azflag) xoriginal[i][2] -= az * sine; +} else if (mstyle == WIGGLE_EIGEN) { + double arg = omega_rotate * delta; + double sine = sin(arg); + if (axflag) xoriginal[i][0] -= ax * sine; + if (ayflag) xoriginal[i][1] -= ay * sine; + if (azflag) xoriginal[i][2] -= az * sine; + } else if (mstyle == ROTATE) { double a[3], b[3], c[3], d[3], disp[3], ddotr; double arg = -omega_rotate * delta; diff --git a/src/fix_move.h b/src/fix_move.h index e6b253a2a2..8023a66c1b 100644 --- a/src/fix_move.h +++ b/src/fix_move.h @@ -73,6 +73,11 @@ class FixMove : public Fix { int maxatom; double **displace, **velocity; + // fix move wiggle_eigen variables + + double **emat; + double *freq; + class AtomVecEllipsoid *avec_ellipsoid; class AtomVecLine *avec_line; class AtomVecTri *avec_tri; @@ -83,3 +88,53 @@ class FixMove : public Fix { #endif #endif + +/* ERROR/WARNING messages: + +E: Illegal ... command + +Self-explanatory. Check the input script syntax and compare to the +documentation for the command. You can use -echo screen as a +command-line option when running LAMMPS to see the offending line. + +E: Fix move cannot set linear z motion for 2d problem + +Self-explanatory. + +E: Fix move cannot set wiggle z motion for 2d problem + +Self-explanatory. + +E: Fix move cannot rotate around non z-axis for 2d problem + +UNDOCUMENTED + +E: Fix move cannot define z or vz variable for 2d problem + +Self-explanatory. + +E: Zero length rotation vector with fix move + +Self-explanatory. + +E: Variable name for fix move does not exist + +Self-explanatory. + +E: Variable for fix move is invalid style + +Only equal-style variables can be used. + +E: Cannot add atoms to fix move variable + +Atoms can not be added afterwards to this fix option. + +E: Resetting timestep size is not allowed with fix move + +This is because fix move is moving atoms based on elapsed time. + +U: Fix move cannot rotate aroung non z-axis for 2d problem + +Self-explanatory. + +*/ From ed0f53cfde74f6c234ddb0ad6ac874069d0fca60 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Tue, 24 May 2022 16:44:06 -0600 Subject: [PATCH 205/585] add citations to doc page, address more NOTE comments --- doc/src/Howto_amoeba.rst | 62 +++++++++++++++++------------ doc/src/kim_commands.rst | 17 ++++---- doc/src/pair_amoeba.rst | 17 ++++++-- src/AMOEBA/amoeba_convolution.cpp | 3 +- src/AMOEBA/amoeba_file.cpp | 10 +++-- src/AMOEBA/amoeba_kspace.cpp | 3 +- src/AMOEBA/amoeba_utils.cpp | 2 +- src/AMOEBA/fix_amoeba_pitorsion.cpp | 6 +-- 8 files changed, 71 insertions(+), 49 deletions(-) diff --git a/doc/src/Howto_amoeba.rst b/doc/src/Howto_amoeba.rst index 87cb09c1d0..a11696e33e 100644 --- a/doc/src/Howto_amoeba.rst +++ b/doc/src/Howto_amoeba.rst @@ -6,7 +6,11 @@ Ponder's group at the U Washington at St Louis. Their implementation in LAMMPS was done using F90 code provided by the Ponder group from their `Tinker MD code `_. -NOTE: What version of AMOEBA and HIPPO does LAMMPS implement? +The current implementaion (May 2022) of AMOEBA in LAMMPS matches the +version discussed in :ref:`(Ponder) `, :ref:`(Ren) +`, and :ref:`(Shi) `. Likewise th current +implementaion of HIPPO in LAMMPS matches the version discussed in +:ref:`(Rackers) `. These force fields can be used when polarization effects are desired in simulations of water, organic molecules, and biomolecules including @@ -14,10 +18,9 @@ proteins, provided that parameterizations (Tinker PRM force field files) are available for the systems you are interested in. Files in the LAMMPS potentials directory with a "amoeba" or "hippo" suffix can be used. The Tinker distribution and website have additional force -field files as well. - -NOTE: Can we include a few Tinker FF files in the LAMMPS distro, -e.g. ubiquitin.prm as potentials/ubiquitin.prm.amoeba ? +field files as well: +`https://github.com/TinkerTools/tinker/tree/release/params +`_. Note that currently, HIPPO can only be used for water systems, but HIPPO files for a variety of small organic and biomolecules are in @@ -27,10 +30,9 @@ included in the LAMMPS distribution when available. ---------- The AMOEBA and HIPPO force fields contain the following terms in their -energy (U) computation. Further details for AMOEBA are in these -papers: :ref:`(Ren) `, :ref:`(Shi) `. Further -details for HIPPO are in this paper: :ref:`(Rackers) -`. +energy (U) computation. Further details for AMOEBA equations are in +:ref:`(Ponder) `, further details for the HIPPO +equations are in :ref:`(Rackers) `. .. math:: @@ -41,8 +43,10 @@ details for HIPPO are in this paper: :ref:`(Rackers) For intermolecular terms, the AMOEBA force field includes only the :math:`U_{hal}`, :math:`U_{multipole}`, :math:`U_{polar}` terms. The HIPPO force field includes all but the :math:`U_{hal}` term. In -LAMMPS, these are all computed by the :doc:`pair_style ` -command. +LAMMPS, these are all computed by the :doc:`pair_style amoeba or hippo +` command. Note that the :math:`U_{multipole}` and +:math:`U_{polar}` terms in this formula are not the same for the +AMOEBA and HIPPO force fields. For intramolecular terms, the :math:`U_{bond}`, :math:`U_{angle}`, :math:`U_{torsion}`, :math:`U_{oop}` terms are computed by the @@ -262,16 +266,20 @@ all the options available to use with the tinker2lmp.py script: Switches and their arguments may be specified in any order. The -xyz switch is required and specifies an input XYZ file as an -argument. The format of this file is an extended XYZ format used by -Tinker for its input. Example \*.xyz files are in the examples/amoeba -directory. The file lists the atoms in the system. Each atom has the -following information: Tinker species name (ignored by LAMMPS), xyz -coordinates, Tinker numeric type, and a list of atom IDs the atom is -bonded to. +argument. The format of this file is an extended XYZ format defined +and used by Tinker for its input. Example \*.xyz files are in the +examples/amoeba directory. The file lists the atoms in the system. +Each atom has the following information: Tinker species name (ignored +by LAMMPS), xyz coordinates, Tinker numeric type, and a list of atom +IDs the atom is bonded to. -NOTE: is this a Tinker-unique augmented XYZ format or standard? Where -can a LAMMPS user get or generate this file for a system they want -to simulate? +Here is more information about the extended XYZ format defined and +used by Tinker, and links to programs that convert standard PDB files +to the extended XYZ format: + +* `http://openbabel.org/docs/current/FileFormats/Tinker_XYZ_format.html `_ +* `https://github.com/emleddin/pdbxyz-xyzpdb `_ +* `https://github.com/TinkerTools/tinker/blob/release/source/pdbxyz.f `_ The -amoeba or -hippo switch is required. It specifies an input AMOEBA or HIPPO PRM force field file as an argument. This should be @@ -297,15 +305,19 @@ compatible with the LAMMPS data file format. ---------- +.. _howto-Ponder: + +**(Ponder)** Ponder, Wu, Ren, Pande, Chodera†, Schnieders, Haque, Mobley, Lambrecht, DiStasio Jr, M. Head-Gordon, Clark, Johnson, T. Head-Gordon, J Phys Chem B, 114, 2549–2564 (2010). + +.. _howto-Rackers: + +**(Rackers)** Rackers, Silva, Wang, Ponder, J Chem Theory Comput, 17, 7056–7084 (2021). + .. _howto-Ren: **(Ren)** Ren and Ponder, J Phys Chem B, 107, 5933 (2003). .. _howto-Shi: -**(Shi)** Shi, Xiz, Znahg, Best, Wu, Ponder, Ren, J Chem Theory Comp, - 9, 4046, 2013. +**(Shi)** Shi, Xiz, Znahg, Best, Wu, Ponder, Ren, J Chem Theory Comp, 9, 4046, 2013. -.. _howto-Rackers: - -**(Rackers)** Rackers and Ponder, J Chem Phys, 150, 084104 (2010). diff --git a/doc/src/kim_commands.rst b/doc/src/kim_commands.rst index 1be907888c..a002b539bd 100644 --- a/doc/src/kim_commands.rst +++ b/doc/src/kim_commands.rst @@ -29,15 +29,16 @@ Examples Description """"""""""" -The *kim command* includes a set of sub-commands that allow LAMMPS users to use -interatomic models (IM) (potentials and force fields) and their predictions for -various physical properties archived in the -`Open Knowledgebase of Interatomic Models (OpenKIM) `_ -repository. +The *kim command* includes a set of sub-commands that allow LAMMPS +users to use interatomic models (IM) (potentials and force fields) and +their predictions for various physical properties archived in the +`Open Knowledgebase of Interatomic Models (OpenKIM) +`_ repository. -Using OpenKIM provides LAMMPS users with immediate access to a large number of -verified IMs and their predictions. OpenKIM IMs have multiple benefits including -`reliability, reproducibility and convenience `_. +Using OpenKIM provides LAMMPS users with immediate access to a large +number of verified IMs and their predictions. OpenKIM IMs have +multiple benefits including `reliability, reproducibility and +convenience `_. .. _IM_types: diff --git a/doc/src/pair_amoeba.rst b/doc/src/pair_amoeba.rst index 5ba16c82c5..5a587e9d30 100644 --- a/doc/src/pair_amoeba.rst +++ b/doc/src/pair_amoeba.rst @@ -101,7 +101,11 @@ The implementation of the AMOEBA and HIPPO force fields in LAMMPS was done using F90 code provided by the Ponder group from their `Tinker MD code `_. -NOTE: what version of AMOEBA and HIPPO does LAMMPS implement? +The current implementaion (May 2022) of AMOEBA in LAMMPS matches the +version discussed in :ref:`(Ponder) `, :ref:`(Ren) +`, and :ref:`(Shi) `. Likewise th current +implementaion of HIPPO in LAMMPS matches the version discussed in +:ref:`(Rackers) `. ---------- @@ -211,6 +215,14 @@ none ---------- +.. _amoeba-Ponder: + +**(Ponder)** Ponder, Wu, Ren, Pande, Chodera†, Schnieders, Haque, Mobley, Lambrecht, DiStasio Jr, M. Head-Gordon, Clark, Johnson, T. Head-Gordon, J Phys Chem B, 114, 2549–2564 (2010). + +.. _amobea-Rackers: + +**(Rackers)** Rackers, Silva, Wang, Ponder, J Chem Theory Comput, 17, 7056–7084 (2021). + .. _amoeba-Ren: **(Ren)** Ren and Ponder, J Phys Chem B, 107, 5933 (2003). @@ -219,6 +231,3 @@ none **(Shi)** Shi, Xiz, Znahg, Best, Wu, Ponder, Ren, J Chem Theory Comp, 9, 4046, 2013. -.. _amoeba-Rackers: - -**(Rackers)** Rackers and Ponder, J Chem Phys, 150, 084104 (2010). diff --git a/src/AMOEBA/amoeba_convolution.cpp b/src/AMOEBA/amoeba_convolution.cpp index bb99f48422..eeeaa66053 100644 --- a/src/AMOEBA/amoeba_convolution.cpp +++ b/src/AMOEBA/amoeba_convolution.cpp @@ -72,7 +72,7 @@ AmoebaConvolution::AmoebaConvolution(LAMMPS *lmp, Pair *pair, flag3d = 1; if (which == POLAR_GRIDC || which == INDUCE_GRIDC) flag3d = 0; - nfft_global = (bingint) nx * ny * nz; + nfft_global = (bigint) nx * ny * nz; // global indices of grid range from 0 to N-1 // nlo_in,nhi_in = lower/upper limits of the 3d sub-brick of @@ -109,7 +109,6 @@ AmoebaConvolution::AmoebaConvolution(LAMMPS *lmp, Pair *pair, // dist[3] = particle position bound = subbox + skin/2.0 // convert to triclinic if necessary // nlo_out,nhi_out = nlo,nhi + stencil size for particle mapping - // NOTE: this needs to be computed same as IGRID in PairAmoeba double *prd,*boxlo,*sublo,*subhi; int triclinic = domain->triclinic; diff --git a/src/AMOEBA/amoeba_file.cpp b/src/AMOEBA/amoeba_file.cpp index 431edfd557..79144dc348 100644 --- a/src/AMOEBA/amoeba_file.cpp +++ b/src/AMOEBA/amoeba_file.cpp @@ -94,9 +94,6 @@ void PairAmoeba::read_prmfile(char *filename) // Atom Type Definitions must come before any other section // other sections can follow in any order - // NOTE: don't use tokenize when not needed, doc string methods better - // NOTE: how to insure each section had enough lines? - int forcefield_flag = 0; int atomtype_flag = 0; int section; @@ -152,7 +149,10 @@ void PairAmoeba::read_prmfile(char *filename) MPI_Bcast(&n,1,MPI_INT,0,world); if (n < 0) break; MPI_Bcast(line,n+1,MPI_CHAR,0,world); - if (n == 0) break; // line starting with #### = next section line + + // line starting with #### = next section line + + if (n == 0) break; // convert all chars in line to lower-case @@ -492,6 +492,8 @@ void PairAmoeba::read_keyfile(char *filename) if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); pcgpeek = utils::numeric(FLERR,words[1],true,lmp); + // NOTE: throw an error if keyword LAMMPS does not recognize ? + } else {} delete [] copy; diff --git a/src/AMOEBA/amoeba_kspace.cpp b/src/AMOEBA/amoeba_kspace.cpp index d67fb50b34..5823ba751e 100644 --- a/src/AMOEBA/amoeba_kspace.cpp +++ b/src/AMOEBA/amoeba_kspace.cpp @@ -209,6 +209,7 @@ void PairAmoeba::bspline_fill() for (int i = 0; i < nlocal; i++) { // NOTE: what about offset/shift and w < 0 or w > 1 + // NOTE: could subtract off nlpts to start with // NOTE: this is place to check that stencil size does not // go out of bounds relative to igrid for a proc's sub-domain // NOTE: could convert x -> lamda for entire set of Nlocal atoms @@ -220,7 +221,7 @@ void PairAmoeba::bspline_fill() ifr = static_cast (fr-eps); w = fr - ifr; igrid[i][0] = ifr; - //igrid[i][0] = ifr + 1; // NOTE: could subtract off nlpts to start with + //igrid[i][0] = ifr + 1; //if (igrid[i][0] == nfft1) igrid[i][0] = 0; bsplgen(w,thetai1[i]); diff --git a/src/AMOEBA/amoeba_utils.cpp b/src/AMOEBA/amoeba_utils.cpp index 7bb95a26a2..b02ef7ca44 100644 --- a/src/AMOEBA/amoeba_utils.cpp +++ b/src/AMOEBA/amoeba_utils.cpp @@ -70,7 +70,7 @@ void PairAmoeba::kmpole() flag = 0; // create a sorted version of bond/angle neighs from special[][] - // NOTE: this is try and do it identically to Tinker + // NOTE: this is to try and do it identically to Tinker // b/c I think in Tinker, atom order matters as to which case is seen fist for (j = 0; j < nspecial[i][0]; j++) diff --git a/src/AMOEBA/fix_amoeba_pitorsion.cpp b/src/AMOEBA/fix_amoeba_pitorsion.cpp index eb4223e43b..68a3d02ea2 100644 --- a/src/AMOEBA/fix_amoeba_pitorsion.cpp +++ b/src/AMOEBA/fix_amoeba_pitorsion.cpp @@ -436,11 +436,9 @@ void FixAmoebaPiTorsion::post_force(int vflag) dphi2 = 2.0 * (cosine2*s2 - sine2*c2); // calculate pi-system torsion energy and master chain rule term - // NOTE: remove ptorunit if 1.0 ? - double ptorunit = 1.0; - e = ptorunit * v2 * phi2; - dedphi = ptorunit * v2 * dphi2; + e = v2 * phi2; + dedphi = v2 * dphi2; // fraction of energy for each atom From 97eb6c195fcffd1c9998fecc09d559090232ee3d Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Tue, 24 May 2022 16:49:30 -0600 Subject: [PATCH 206/585] updated examples --- examples/amoeba/Test.sh | 28 +- examples/amoeba/dump.ubi | 19492 ---------------- examples/amoeba/in.water_box.amoeba.test | 5 +- examples/amoeba/in.water_box.hippo.test | 5 +- examples/amoeba/in.water_dimer.amoeba.test | 5 +- examples/amoeba/in.water_dimer.hippo.test | 5 +- examples/amoeba/in.water_hexamer.amoeba.test | 5 +- examples/amoeba/in.water_hexamer.hippo.test | 5 +- examples/amoeba/log.ubi.1.test | 48 +- examples/amoeba/log.ubi.32.test | 48 +- examples/amoeba/log.water_box.amoeba.1.test | 45 +- examples/amoeba/log.water_box.amoeba.32.test | 45 +- examples/amoeba/log.water_box.hippo.1.test | 53 +- examples/amoeba/log.water_box.hippo.32.test | 49 +- examples/amoeba/log.water_dimer.amoeba.1.test | 43 +- examples/amoeba/log.water_dimer.amoeba.4.test | 43 +- examples/amoeba/log.water_dimer.hippo.1.test | 47 +- examples/amoeba/log.water_dimer.hippo.4.test | 49 +- .../amoeba/log.water_hexamer.amoeba.1.test | 43 +- .../amoeba/log.water_hexamer.amoeba.4.test | 43 +- .../amoeba/log.water_hexamer.hippo.1.test | 47 +- .../amoeba/log.water_hexamer.hippo.4.test | 47 +- 22 files changed, 345 insertions(+), 19855 deletions(-) delete mode 100644 examples/amoeba/dump.ubi diff --git a/examples/amoeba/Test.sh b/examples/amoeba/Test.sh index 54963918c6..68d81c8aef 100644 --- a/examples/amoeba/Test.sh +++ b/examples/amoeba/Test.sh @@ -2,65 +2,65 @@ # dimer -../../src/lmp_mpi < in.water_dimer.amoeba +../../src/lmp_mpi < in.water_dimer.amoeba.test mv log.lammps log.water_dimer.amoeba.1.test mv dump.water_dimer dump.water_dimer.amoeba.1.test -mpirun -np 4 ../../src/lmp_mpi < in.water_dimer.amoeba +mpirun -np 4 ../../src/lmp_mpi < in.water_dimer.amoeba.test mv log.lammps log.water_dimer.amoeba.4.test mv dump.water_dimer dump.water_dimer.amoeba.4.test -../../src/lmp_mpi < in.water_dimer.hippo +../../src/lmp_mpi < in.water_dimer.hippo.test mv log.lammps log.water_dimer.hippo.1.test mv dump.water_dimer dump.water_dimer.hippo.1.test -mpirun -np 4 ../../src/lmp_mpi < in.water_dimer.hippo +mpirun -np 4 ../../src/lmp_mpi < in.water_dimer.hippo.test mv log.lammps log.water_dimer.hippo.4.test mv dump.water_dimer dump.water_dimer.hippo.4.test # hexamer -../../src/lmp_mpi < in.water_hexamer.amoeba +../../src/lmp_mpi < in.water_hexamer.amoeba.test mv log.lammps log.water_hexamer.amoeba.1.test mv dump.water_hexamer dump.water_hexamer.amoeba.1.test -mpirun -np 4 ../../src/lmp_mpi < in.water_hexamer.amoeba +mpirun -np 4 ../../src/lmp_mpi < in.water_hexamer.amoeba.test mv log.lammps log.water_hexamer.amoeba.4.test mv dump.water_hexamer dump.water_hexamer.amoeba.4.test -../../src/lmp_mpi < in.water_hexamer.hippo +../../src/lmp_mpi < in.water_hexamer.hippo.test mv log.lammps log.water_hexamer.hippo.1.test mv dump.water_hexamer dump.water_hexamer.hippo.1.test -mpirun -np 4 ../../src/lmp_mpi < in.water_hexamer.hippo +mpirun -np 4 ../../src/lmp_mpi < in.water_hexamer.hippo.test mv log.lammps log.water_hexamer.hippo.4.test mv dump.water_hexamer dump.water_hexamer.hippo.4.test # water box -../../src/lmp_mpi < in.water_box.amoeba +../../src/lmp_mpi < in.water_box.amoeba.test mv log.lammps log.water_box.amoeba.1.test mv dump.water_box dump.water_box.amoeba.1.test -mpirun -np 32 ../../src/lmp_mpi < in.water_box.amoeba +mpirun -np 32 ../../src/lmp_mpi < in.water_box.amoeba.test mv log.lammps log.water_box.amoeba.32.test mv dump.water_box dump.water_box.amoeba.32.test -../../src/lmp_mpi < in.water_box.hippo +../../src/lmp_mpi < in.water_box.hippo.test mv log.lammps log.water_box.hippo.1.test mv dump.water_box dump.water_box.hippo.1.test -mpirun -np 32 ../../src/lmp_mpi < in.water_box.hippo +mpirun -np 32 ../../src/lmp_mpi < in.water_box.hippo.test mv log.lammps log.water_box.hippo.32.test mv dump.water_box dump.water_box.hippo.32.test # ubiquitin -../../src/lmp_mpi < in.ubiquitin +../../src/lmp_mpi < in.ubiquitin.test mv log.lammps log.ubi.1.test mv dump.ubi dump.ubi.1.test -mpirun -np 32 ../../src/lmp_mpi < in.ubiquitin +mpirun -np 32 ../../src/lmp_mpi < in.ubiquitin.test mv log.lammps log.ubi.32.test mv dump.ubi dump.ubi.32.test diff --git a/examples/amoeba/dump.ubi b/examples/amoeba/dump.ubi deleted file mode 100644 index 743c5e68dc..0000000000 --- a/examples/amoeba/dump.ubi +++ /dev/null @@ -1,19492 +0,0 @@ -ITEM: TIMESTEP -0 -ITEM: NUMBER OF ATOMS -9737 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 5.4990000000000002e+01 -0.0000000000000000e+00 4.1909999999999997e+01 -0.0000000000000000e+00 4.1909999999999997e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 9.9631 5.60476 0.008413 6.29384 29.5246 19.0744 -2 2 9.59585 5.61686 40.5223 49.6095 -15.082 -19.7261 -3 2 8.19009 6.07902 40.3725 -38.3002 -36.0401 31.6494 -4 3 7.228 5.27674 40.5663 25.6537 34.3003 -15.2325 -5 4 9.24854 5.32486 0.671238 -4.4712 -3.37565 -7.28982 -6 4 10.3108 6.54317 0.309331 -11.8382 -28.5043 -8.77497 -7 4 10.7093 4.95217 0.170763 9.79439 -2.80927 4.02983 -8 4 10.3426 6.38567 40.0332 -19.5644 -29.2331 3.89265 -9 2 9.77742 4.13431 39.9813 -28.2245 -12.7597 2.79543 -10 2 9.48564 3.81758 38.4974 43.5672 -24.1926 -8.96475 -11 5 10.1176 2.11667 38.0047 -9.19737 11.9016 12.5734 -12 2 9.21456 1.10205 39.2112 31.2522 23.9396 11.6177 -13 4 8.99594 3.48122 40.5964 28.5446 19.8656 -13.413 -14 4 10.8136 3.75653 40.1807 -3.6049 4.77507 7.99264 -15 4 10.0744 4.47991 37.8007 -16.03 7.55553 14.4224 -16 4 8.42529 3.84402 38.2863 -20.8998 9.83371 -6.83213 -17 4 9.47601 1.46641 40.2263 -2.07893 -1.87234 0.341628 -18 4 9.53146 0.065851 39.1813 1.34892 -20.4385 -9.90461 -19 4 8.1577 1.22135 39.0727 -30.8502 -1.48556 -5.54631 -20 1 8.07565 7.408 40.3203 38.3461 4.68909 -14.5778 -21 2 6.84679 8.08521 40.1985 -59.0929 12.5985 8.76694 -22 2 6.18936 7.48414 38.9048 -11.7821 0.575019 41.3478 -23 3 6.7346 7.67531 37.8418 13.9355 0.826162 -41.115 -24 4 8.95137 7.92937 40.1018 -13.7432 5.12585 4.7357 -25 4 6.17099 7.78674 41.0889 17.7478 9.29385 -16.8634 -26 2 7.04543 9.68435 40.1788 6.06779 -36.4281 36.3417 -27 2 5.78315 10.5437 40.1541 10.0153 13.6856 -31.2349 -28 2 4.87823 10.4891 38.8981 8.0898 32.2503 -21.0798 -29 3 5.10035 11.2936 37.9551 -6.38068 -25.249 23.2549 -30 1 3.78765 9.69754 38.9447 7.74282 -10.5609 -2.0448 -31 4 7.77413 9.91905 39.4336 6.93206 10.4159 -38.5359 -32 4 7.65159 10.0279 41.0787 -15.5363 -12.6708 -2.68622 -33 4 6.21166 11.5927 40.0353 -14.0103 -9.11046 14.0038 -34 4 5.24199 10.4471 41.1154 -6.90019 6.03163 0.39253 -35 4 3.64982 9.13451 39.798 -8.63839 -3.4701 -4.98201 -36 4 3.18526 9.53497 38.0983 12.4509 11.2825 18.2671 -37 1 5.03649 6.76821 39.0271 29.2025 12.626 -49.9624 -38 2 4.1742 6.30537 37.9199 2.45922 -5.77224 11.4432 -39 2 2.7281 6.64357 38.2301 -33.27 13.9739 -28.2234 -40 3 2.48558 7.27851 39.247 -7.20167 1.94081 18.2399 -41 4 4.56901 6.92293 39.8729 -36.0812 -3.10094 47.9009 -42 4 4.41115 6.93099 37.0362 4.08063 -6.87028 -11.6053 -43 2 4.30896 4.77224 37.6863 5.60806 -34.2262 -10.7438 -44 2 3.61194 3.83713 38.7945 21.7291 41.8848 -7.6362 -45 2 5.81981 4.32753 37.5156 -0.302636 -10.5955 -12.2236 -46 2 3.74184 2.37563 38.4472 -21.3499 -20.7746 -35.862 -47 4 3.79188 4.51145 36.7016 6.3754 10.432 9.00978 -48 4 2.54774 4.08441 38.8361 -15.7139 1.18722 1.17999 -49 4 4.01487 4.13828 39.7949 0.987415 -11.5324 -1.87366 -50 4 6.38959 4.49596 38.46 -5.87199 -9.93517 1.91854 -51 4 6.36771 4.97617 36.7815 -14.8228 -10.6264 -0.132465 -52 4 5.90888 3.19548 37.1534 1.72477 39.701 11.5881 -53 4 3.39383 2.18531 37.3739 6.37275 7.50384 16.1992 -54 4 3.10231 1.69487 39.022 -2.76045 -1.11045 15.6564 -55 4 4.76015 2.00007 38.4839 16.883 -5.45935 8.37891 -56 1 1.68415 6.36719 37.3348 37.2769 -12.9922 15.6035 -57 2 0.304736 6.65563 37.6783 -19.186 -35.7743 -0.468083 -58 2 54.3638 5.41499 37.39 23.5408 9.01503 -19.9847 -59 3 54.8016 4.481 36.67 -18.0502 12.9096 17.6943 -60 4 1.81134 5.6821 36.5646 -2.38907 6.77101 2.69516 -61 4 0.26398 6.68603 38.7911 -5.02605 17.0245 3.77253 -62 2 54.6928 7.87629 36.9427 9.14228 37.5998 28.2049 -63 2 0.656467 9.08157 36.7109 -0.0956801 -8.96924 -14.639 -64 2 1.56488 9.23116 35.5658 -28.7887 -16.4207 21.28 -65 2 0.518242 10.1807 37.599 12.0453 -33.0617 -42.3022 -66 2 2.2549 10.4284 35.3456 -0.685553 9.51875 21.9154 -67 2 1.26608 11.2953 37.3573 -6.55985 56.8791 72.0683 -68 2 2.14201 11.4551 36.3269 43.9558 24.4422 -61.5967 -69 4 53.8494 8.28091 37.614 11.6877 -9.2043 -14.6276 -70 4 54.1796 7.56606 36.0251 1.84695 0.514683 -15.8045 -71 4 1.67027 8.40603 34.832 -2.56062 3.42592 3.08894 -72 4 54.8243 10.1788 38.4192 -16.1978 -2.83683 23.7337 -73 4 2.90465 10.5398 34.4584 1.04403 1.06161 3.93542 -74 4 1.2044 12.0958 38.199 3.2453 -15.1518 -32.2206 -75 4 2.76002 12.4636 36.1598 -24.4207 -43.5556 11.8549 -76 1 53.0705 5.5478 37.8043 -13.4682 25.7632 10.8407 -77 2 51.945 4.63101 37.5291 33.8243 -29.5042 -37.7332 -78 2 50.7838 5.44293 36.986 4.21111 -0.422475 -19.7833 -79 3 50.2621 6.29965 37.7355 -1.55474 -12.1519 -25.7528 -80 4 52.801 6.45436 38.3333 3.61532 -42.2821 -15.9338 -81 4 52.3053 3.83112 36.7028 -14.0928 30.7972 24.0178 -82 2 51.5456 3.79903 38.7793 9.75018 1.06621 4.26496 -83 2 50.3519 2.79661 38.4832 35.7171 10.1602 1.47909 -84 2 52.8174 3.02556 39.2171 -10.4567 -30.55 12.3487 -85 4 51.3202 4.51835 39.6193 -10.3559 -7.38818 -7.14654 -86 4 50.5612 2.13754 37.5331 -9.75373 16.6535 26.894 -87 4 49.4557 3.43665 38.3668 -10.8276 -7.01925 -6.76558 -88 4 50.2008 2.17632 39.4156 -2.83245 -1.1989 -13.0752 -89 4 53.3224 3.52205 40.064 3.32837 5.49303 2.41605 -90 4 53.5736 2.86114 38.4382 5.5955 2.25759 -8.48168 -91 4 52.5769 1.98664 39.5815 -0.855844 10.0945 -0.110617 -92 1 50.4393 5.19673 35.6351 -19.7264 9.67141 42.9571 -93 2 49.1691 5.71413 35.1171 8.57247 21.8964 -7.76629 -94 2 48.0882 4.65728 35.3507 -19.9883 30.8425 14.9148 -95 3 48.2827 3.53875 34.9335 -4.48089 -38.0316 -8.70437 -96 4 50.7426 4.33028 35.1784 2.31221 -1.81777 -1.86606 -97 4 48.9711 6.6281 35.7521 -11.2206 -0.672417 -16.6265 -98 2 49.2032 6.03091 33.5236 -0.851856 65.2811 26.1578 -99 2 47.9587 6.87959 32.9935 21.6676 -24.5773 11.3759 -100 2 48.0434 7.32811 31.5002 51.7858 -12.5586 -5.19204 -101 2 48.2074 6.22405 30.3724 28.294 -23.2516 17.4346 -102 1 48.1983 6.77555 28.9911 -71.9632 -28.6889 -6.605 -103 4 49.3393 5.11986 33.0139 -2.20502 -45.3575 -27.512 -104 4 50.0955 6.63289 33.1892 -0.645528 -4.64769 17.8413 -105 4 47.8013 7.74388 33.6913 1.36166 0.224784 -7.99748 -106 4 47.0904 6.22572 33.1496 -13.2574 -0.904539 -3.87726 -107 4 49.004 7.98659 31.3992 -27.9616 -9.11626 3.58403 -108 4 47.1978 7.96127 31.27 -20.0009 14.5444 -5.73856 -109 4 47.5417 5.33248 30.4619 -18.467 18.3391 -3.45282 -110 4 49.1897 5.66674 30.5732 -8.59668 22.4275 -14.4147 -111 4 48.9982 7.27964 28.7313 27.9214 19.6218 -9.55881 -112 4 47.3685 7.40493 28.8518 27.8731 -11.8414 7.77703 -113 4 48.0065 6.08598 28.2169 17.275 11.5652 28.2934 -114 1 46.9206 5.03778 35.9702 10.3577 18.9682 5.15831 -115 2 45.6557 4.25932 36.0398 9.08885 -0.641191 -14.1305 -116 2 44.8836 4.39003 34.674 17.924 -7.95306 73.8288 -117 3 45.3111 5.13887 33.8455 4.25406 24.8458 -47.415 -118 4 46.9247 5.98842 36.4259 -8.42518 -21.6093 -9.66 -119 4 45.9322 3.16772 36.074 -4.07513 2.77881 8.35057 -120 2 44.7235 4.66099 37.2497 -7.79148 27.6424 25.8282 -121 3 44.4559 6.1146 37.2032 37.085 -18.356 15.5747 -122 2 45.2448 4.26963 38.7181 22.7861 29.0575 -8.8559 -123 4 43.727 4.13168 37.1283 17.3832 10.5512 -0.864114 -124 4 45.2761 6.59903 37.5183 -34.0557 -21.4787 -11.7364 -125 4 45.8733 4.97275 39.4014 -10.271 -7.81482 -36.7347 -126 4 45.822 3.36133 38.5799 14.1835 -15.9263 3.29814 -127 4 44.4672 3.97387 39.4102 -27.3329 -5.40347 3.37723 -128 1 43.7561 3.68722 34.6039 -10.1769 -38.5504 10.0379 -129 2 42.7898 3.65331 33.5354 16.9998 -6.12306 -24.86 -130 2 41.7694 4.78815 33.7404 2.26966 -0.410412 -51.1213 -131 3 41.2522 5.37284 32.7445 13.6537 -18.3748 18.9894 -132 4 43.5295 2.98811 35.3697 5.99608 22.1557 -16.865 -133 4 43.3523 3.94914 32.5036 -19.5402 -19.5629 37.0771 -134 2 42.0755 2.18627 33.4863 21.9074 34.2086 -29.4327 -135 2 42.9391 0.859767 33.721 -6.85443 30.257 35.6042 -136 2 42.2358 41.4668 33.4285 -9.81834 -3.65893 -31.5778 -137 2 44.2283 0.854864 32.9471 53.2312 13.9788 40.9195 -138 4 41.6117 2.20331 32.4686 -4.39523 -13.2201 2.61812 -139 4 41.2586 2.27352 34.2121 -10.6776 -10.6054 4.67488 -140 4 43.2056 0.83773 34.8124 -0.343624 1.56324 -2.51079 -141 4 42.8118 40.5237 33.3983 6.69029 -0.569008 16.3673 -142 4 41.9597 41.5484 32.3684 -17.7546 -2.75522 -9.07631 -143 4 41.3245 41.3357 34.0216 -8.62626 -3.98831 3.9624 -144 4 44.0827 0.853311 31.8896 -3.53557 -4.02089 -36.565 -145 4 44.8236 41.822 33.2847 -5.06735 25.2561 -15.1823 -146 4 44.8583 1.80877 33.1923 -14.5958 -31.7921 -4.90526 -147 1 41.5264 5.19611 34.9737 -24.8334 44.6246 6.63495 -148 2 40.6685 6.33721 35.2699 -7.96634 19.3021 -16.1623 -149 2 41.3876 7.74941 35.097 -11.5591 -21.8484 1.81155 -150 3 40.7047 8.75309 34.8417 -6.4948 4.14558 0.128999 -151 4 41.7654 4.68652 35.8013 13.1043 -20.8107 18.8359 -152 4 39.8731 6.44712 34.4383 10.8594 -11.0445 14.3032 -153 2 39.8592 6.12601 36.6093 -15.5564 -7.24317 -37.5678 -154 3 40.7443 5.88444 37.6633 23.6025 16.5055 19.3857 -155 2 38.9047 4.85477 36.5395 -12.0583 61.1722 12.675 -156 4 39.322 7.07341 36.7706 -11.99 4.52079 9.89046 -157 4 41.1265 6.74598 37.8781 -3.93551 -10.4676 -4.79928 -158 4 38.0585 4.98564 35.7954 18.0693 -6.53498 -0.435941 -159 4 38.3566 4.77654 37.5171 8.14363 -6.92414 -3.72239 -160 4 39.543 3.99696 36.3828 0.165947 -30.6128 -6.86199 -161 1 42.7342 7.80416 35.136 -13.9315 11.8694 11.7976 -162 2 43.5142 9.02936 34.9481 17.7181 -46.9691 35.2138 -163 2 44.5073 9.42999 36.0349 -55.8537 -50.7646 50.0035 -164 3 45.375 10.2125 35.7599 43.422 25.9365 -4.74067 -165 4 43.1984 6.94617 35.4338 19.599 0.647333 4.29925 -166 4 44.1406 8.86955 34.0842 9.16679 3.97336 -28.1373 -167 4 42.9197 9.91228 34.8204 -18.5221 19.1219 -12.9063 -168 1 44.2798 8.93745 37.3587 -4.0043 10.1489 -58.0949 -169 2 45.1948 9.27519 38.4238 -4.17993 36.3676 -26.0855 -170 2 46.5575 8.73344 38.0061 12.5522 -20.4469 18.6928 -171 3 46.7331 7.49794 37.7681 -6.88831 31.8582 -6.20611 -172 4 43.377 8.45873 37.5311 9.37776 2.67644 11.4724 -173 4 45.2318 10.4158 38.3238 5.33405 -13.6354 14.6161 -174 2 44.7823 8.84756 39.8415 35.39 -32.4267 -9.44324 -175 2 45.5211 9.64049 40.9405 -33.0234 -16.4934 27.578 -176 2 45.0293 11.1067 41.0295 26.955 13.1382 1.75579 -177 2 45.9939 11.883 0.056845 5.44769 -3.52142 -7.77113 -178 1 45.567 13.2463 0.389189 -21.8942 22.5552 58.7427 -179 4 44.9649 7.71121 39.9163 -1.68078 22.7299 4.94117 -180 4 43.7292 8.96914 40.0006 -34.3585 3.91778 0.788359 -181 4 46.6326 9.56148 40.8729 -4.12637 -0.755434 -1.7729 -182 4 45.1589 9.15652 0.052119 21.5355 9.01144 -26.2886 -183 4 44.0384 11.1525 41.4882 -17.6691 -1.8484 1.78047 -184 4 44.9645 11.6456 40.0488 1.32443 -5.52779 3.51863 -185 4 46.9936 12.0079 41.4163 -11.0521 -7.71607 17.8496 -186 4 46.0863 11.2417 1.01939 6.64185 25.7549 -16.0759 -187 4 45.6176 13.9315 41.5535 6.39074 -1.54943 -2.93714 -188 4 46.1207 13.6426 1.21669 -15.3499 -18.2055 -38.2327 -189 4 44.572 13.3465 0.725918 28.6554 -12.4083 -12.8179 -190 1 47.5723 9.62675 38.0225 1.62241 16.525 -13.2778 -191 2 48.9413 9.31976 37.6447 28.3505 6.17866 3.85392 -192 2 49.7947 9.65595 38.897 -51.2415 76.6103 -24.0977 -193 3 49.6063 10.7902 39.4401 12.9093 -42.4425 -12.577 -194 4 47.4538 10.6389 38.3066 -1.81401 -22.4625 -4.08398 -195 4 49.0905 8.23756 37.4201 -8.03606 -0.867672 -0.903629 -196 2 49.3577 10.1392 36.3514 -15.5639 -8.86216 -34.5575 -197 3 48.3381 9.84531 35.2995 20.2521 4.60838 26.9691 -198 2 50.6821 9.73379 35.6575 -13.1705 -1.52152 26.2758 -199 4 49.443 11.2403 36.5183 -14.2645 -0.263993 8.70321 -200 4 47.5106 10.2398 35.5579 0.218555 2.62212 3.26783 -201 4 50.9323 10.3465 34.7687 -2.88514 -3.55444 -7.60949 -202 4 50.7732 8.65192 35.4951 -3.14548 -9.24106 -12.1943 -203 4 51.4763 9.94768 36.3674 17.1427 5.0591 10.0517 -204 1 50.5022 8.69828 39.4305 24.0939 -43.466 77.1583 -205 2 51.0483 8.71922 40.8082 -0.802123 10.2433 -32.8315 -206 2 52.5183 8.33859 40.7231 46.1376 25.1574 58.8821 -207 3 52.8914 7.33748 40.1143 13.0446 10.4001 -14.6089 -208 4 50.6189 7.73433 39.1341 -5.48208 -8.91176 -29.3848 -209 4 51.0045 9.75097 41.1725 -0.547397 17.2241 4.09797 -210 2 50.2922 7.85282 41.8455 19.6626 -50.7873 -7.63422 -211 2 50.2811 6.29504 41.471 -17.2864 -17.6708 26.7503 -212 2 48.8668 8.31684 0.212195 -17.3783 63.506 12.4232 -213 2 49.3691 5.38294 0.512646 14.3884 65.6628 -4.02696 -214 4 50.9326 7.9114 0.860642 -12.3241 5.1929 3.57402 -215 4 51.3127 5.83882 41.5287 -4.74499 10.5855 -5.5164 -216 4 49.8921 6.13652 40.4532 1.6457 0.843055 -11.9856 -217 4 48.0317 8.06123 41.424 13.0217 -7.20036 -2.54126 -218 4 48.8693 9.49201 0.254246 -0.917701 -32.4673 -2.46528 -219 4 48.5263 8.05212 1.23597 1.41612 -6.96817 -0.649274 -220 4 48.2816 5.57755 0.309314 6.34191 -1.32326 5.14384 -221 4 49.6363 5.72968 1.56057 -11.1106 -15.1353 -5.99489 -222 4 49.54 4.32324 0.397743 7.27301 -24.1582 -2.3836 -223 1 53.3925 9.14738 41.5454 -19.7766 -15.6836 -47.6014 -224 2 54.8543 9.29866 41.641 -12.5045 -20.0873 29.727 -225 2 0.407838 8.25913 0.762984 -29.7207 32.5524 -37.8245 -226 3 54.8643 8.2564 1.86493 17.0269 -29.0845 20.332 -227 4 52.9285 9.69819 0.341812 -9.11605 14.2566 13.2302 -228 4 0.291486 9.0623 40.6877 9.99865 -5.39191 -34.8298 -229 2 0.359683 10.7121 0.203065 -6.90664 -3.88067 -14.6485 -230 3 54.4765 11.8025 41.752 -11.2022 -21.2627 -5.88002 -231 2 1.6614 11.1001 41.4135 2.5167 -27.9916 -13.3179 -232 4 0.487415 10.6137 1.28953 0.410521 18.1219 13.0764 -233 4 54.0953 12.1937 0.613553 1.59003 1.59721 11.7532 -234 4 1.92456 12.0955 41.7398 14.8193 23.7252 4.53742 -235 4 1.52762 11.126 40.2979 3.61624 1.93597 7.36374 -236 4 2.5241 10.4069 41.6364 -8.38015 7.04993 1.52106 -237 1 1.45864 7.53391 0.367476 0.545631 9.71791 -21.8799 -238 2 2.25081 6.65311 1.15507 26.446 -0.0641839 -18.4938 -239 2 3.7671 6.96757 0.917085 -57.4365 -22.4689 85.9929 -240 3 4.15047 7.41488 41.7757 21.4144 12.1214 -29.7802 -241 4 1.8001 7.62601 41.3064 3.76941 -0.348546 3.21752 -242 4 1.98413 6.84865 2.19976 1.77378 -4.57114 13.3572 -243 2 1.98593 5.20856 0.673411 -39.0557 8.05152 -2.47083 -244 2 0.499001 4.77546 0.950638 51.92 -35.3278 3.54994 -245 2 0.302449 3.38226 0.307039 12.2804 5.92691 27.6936 -246 2 0.318833 4.59091 2.46762 -57.1886 17.9845 23.4913 -247 4 2.62035 4.47984 1.15306 24.0478 -12.5257 10.4353 -248 4 2.17019 5.14075 41.4887 6.74012 -0.473312 -2.7006 -249 4 54.8482 5.46061 0.448133 -33.0903 28.7369 -7.07308 -250 4 54.2241 3.15851 0.337643 -14.6094 -12.7265 -2.24176 -251 4 0.881511 2.58656 0.876485 -8.96903 11.0382 -11.5819 -252 4 0.635114 3.38296 41.1822 2.70741 -4.49002 -20.1461 -253 4 0.991181 3.80938 2.86091 2.53728 -4.51346 7.06316 -254 4 54.1796 4.30541 2.72425 38.6722 3.44969 -10.622 -255 4 0.495432 5.52724 3.08531 2.73328 -11.7655 -13.2166 -256 1 4.49387 6.66874 2.05101 59.25 35.5651 -63.8633 -257 2 5.97745 6.82619 2.08157 -13.5783 -40.6566 -15.6714 -258 2 6.57448 5.47381 2.54294 67.6927 12.9151 50.3283 -259 3 7.53922 5.43765 3.33186 -5.78511 6.85237 -12.8739 -260 4 4.10191 6.33546 2.9164 -11.2688 -10.0369 11.6191 -261 4 6.35409 6.85375 1.02753 1.73229 12.3732 3.55997 -262 2 6.47001 8.00523 2.96248 -35.1701 -2.47648 -9.01657 -263 2 6.52316 9.38515 2.26526 -52.089 -36.3571 -52.5381 -264 2 6.66039 10.5311 3.17647 23.2175 30.5211 32.7092 -265 3 7.81872 10.9467 3.49478 5.10838 -9.19539 -6.96115 -266 3 5.64173 11.0573 3.6767 -20.5888 -1.64097 0.158765 -267 4 7.42654 7.87231 3.41702 35.4584 -16.2138 5.63399 -268 4 5.81838 7.86205 3.84167 -4.54492 27.3919 10.2645 -269 4 5.56237 9.49095 1.59664 20.5708 1.89307 25.306 -270 4 7.29681 9.38215 1.47849 13.2355 1.21078 1.19218 -271 1 6.08096 4.31767 2.17259 -39.414 -15.8224 -24.7678 -272 2 6.39518 2.91476 2.36043 4.12081 37.0723 19.1814 -273 2 7.75633 2.62628 1.79624 63.8838 -9.4865 -25.3011 -274 3 8.33634 3.36937 0.946953 -27.4154 -16.213 26.3787 -275 4 5.28658 4.43126 1.58002 -24.0887 -1.16266 -20.2566 -276 4 6.54455 2.77577 3.45017 -8.86613 -5.70482 8.60941 -277 2 5.25427 2.02933 1.82805 -30.6144 -48.6247 5.61864 -278 2 3.85552 2.1153 2.66383 78.486 27.413 32.1434 -279 2 4.87851 2.27508 0.297641 -10.4566 -15.7718 22.2154 -280 4 5.65998 0.937168 1.99721 -15.6319 23.5495 -14.0675 -281 4 3.98898 1.63213 3.72107 -1.04911 23.3354 -24.3429 -282 4 3.15409 1.48884 2.20213 -45.477 -24.0418 -26.2275 -283 4 3.51802 3.20813 2.70746 -2.40249 -20.6527 6.6832 -284 4 4.39172 3.24426 0.119355 -1.44384 9.21297 0.0772101 -285 4 4.19746 1.51559 41.6955 12.4172 8.09212 16.5491 -286 4 5.82002 2.28129 41.6778 17.5327 1.3005 -22.4945 -287 1 8.43941 1.53208 2.30673 1.7292 42.4201 -39.4356 -288 2 9.76672 1.10452 1.81012 11.995 -19.5667 23.3003 -289 2 9.60964 41.7637 0.921245 4.05677 21.7498 -11.1929 -290 3 8.59567 41.087 1.06007 7.18507 -15.5872 -8.58634 -291 4 7.90606 0.81761 2.76924 -8.42032 -19.931 16.3865 -292 4 10.4026 1.87877 1.34085 -18.5158 15.1062 -12.7744 -293 2 10.6232 0.647963 3.0246 -34.7832 -39.5023 14.4787 -294 2 11.0993 1.6812 4.04079 16.2934 16.5377 23.708 -295 2 12.4719 2.27616 3.59128 -46.8378 -2.52013 6.7155 -296 3 13.4675 1.63575 4.02276 22.0629 14.477 -13.463 -297 3 12.4471 3.24187 2.73298 15.8946 -22.2661 28.0778 -298 4 11.4641 0.045385 2.63277 10.8271 5.92943 5.75519 -299 4 10.0353 41.7446 3.607 8.35649 20.5438 -12.0897 -300 4 11.2832 1.11765 5.0427 -4.51453 13.9694 -21.6118 -301 4 10.341 2.4932 4.3105 9.65416 -13.2167 -8.7997 -302 1 10.6494 41.4676 0.039711 8.78515 0.440053 18.9323 -303 2 10.7217 40.2184 41.1909 10.2574 -28.5822 12.1248 -304 2 10.6889 38.8907 0.171469 -17.3791 70.2346 -13.2363 -305 3 10.1368 37.8928 41.652 0.864281 -20.5458 12.6113 -306 4 9.82473 40.2067 40.5786 -14.2689 -8.84554 -18.4029 -307 2 12.0478 40.1799 40.3262 -31.3786 20.6535 10.6233 -308 2 12.4388 41.6551 40.4794 16.223 20.8678 -10.392 -309 2 11.8805 0.34241 41.7792 -28.1233 -36.7072 -34.4959 -310 4 11.9102 39.8982 39.2292 -1.08614 0.893428 17.4874 -311 4 12.7409 39.4563 40.8087 9.93344 3.46544 -3.32375 -312 4 12.0845 0.391154 39.5895 8.62314 -16.2997 14.2071 -313 4 13.5502 41.7447 40.5643 -1.70925 0.910467 -12.4735 -314 4 11.7305 1.40344 41.6414 -9.5626 24.5309 -2.35213 -315 4 12.5687 0.26268 0.684216 19.8182 -9.73862 27.9097 -316 1 11.1854 39.0885 1.40191 34.1901 -11.3327 18.3686 -317 2 11.4785 38.09 2.41707 -37.5808 13.2867 4.32174 -318 2 10.2405 37.7763 3.3402 -0.155099 -13.1844 6.87934 -319 3 10.4378 36.9653 4.27207 -11.6928 9.67513 -22.7546 -320 4 11.6756 39.9703 1.62918 -8.97807 -2.58442 -2.36164 -321 4 11.7153 37.147 1.89269 -3.37493 -11.1801 -2.58831 -322 2 12.7263 38.4682 3.25859 -32.7454 -15.529 27.3397 -323 3 12.5885 39.7408 3.87129 1.54426 18.5893 -11.5354 -324 4 13.5945 38.4441 2.61946 23.9879 5.88222 -14.7576 -325 4 12.9197 37.685 4.04183 -3.566 10.9198 -2.82194 -326 4 11.9285 39.8531 4.57214 8.5625 -16.1459 -5.7164 -327 1 8.98961 38.3717 3.14779 19.3135 28.1448 -76.0315 -328 2 7.78009 38.1002 3.90315 -4.26896 22.0341 0.229441 -329 2 6.83069 37.1869 3.18241 -25.8564 -25.3069 -16.1867 -330 3 6.84398 36.9785 1.97125 20.9058 23.903 -13.4458 -331 4 8.79049 38.9506 2.20714 10.5577 -30.8167 54.9659 -332 4 8.11274 37.5073 4.75427 1.14536 -6.32615 23.8911 -333 2 7.0077 39.4163 4.32571 4.21253 -4.87986 18.678 -334 2 7.75781 40.1168 5.42156 46.58 -14.1846 12.934 -335 3 8.30143 41.2262 5.21331 -14.6188 11.6514 -5.86083 -336 3 8.10545 39.4797 6.46784 -18.045 3.20128 -4.6129 -337 4 6.01572 39.173 4.78754 -1.72287 0.045533 -10.2864 -338 4 6.87032 40.2048 3.55457 -4.98407 -10.6589 -12.5629 -339 1 5.91154 36.4899 3.88964 18.6928 -0.691686 25.3425 -340 2 4.98537 35.571 3.20749 -24.0931 31.8814 30.8723 -341 2 3.79198 36.4499 2.67545 58.5623 50.3783 54.6165 -342 3 3.60244 37.6478 3.05835 4.98938 -42.2114 -12.2812 -343 4 5.945 36.5545 4.93654 -10.5756 -4.83423 -16.3239 -344 4 5.5221 35.038 2.40161 -3.05594 2.46612 -11.4716 -345 2 4.40384 34.4728 4.15145 -1.70261 45.9252 5.92389 -346 3 3.98498 35.0725 5.41787 -8.00202 -46.5665 -16.5053 -347 2 5.48475 33.4747 4.46048 0.249803 -29.9924 71.6177 -348 4 3.54337 34.0389 3.61058 -6.82183 -12.9435 7.69028 -349 4 3.62675 34.2747 5.86698 6.39679 27.749 2.05336 -350 4 5.85279 32.9868 3.57629 11.3184 -16.9973 -22.3871 -351 4 5.09248 32.6743 5.23041 8.97186 17.4623 -32.7541 -352 4 6.34746 33.9006 5.03324 -0.476546 4.78606 -11.5797 -353 1 3.00152 35.8184 1.87366 -46.1462 -42.5584 -55.0681 -354 2 1.77021 36.3468 1.35692 -36.7765 14.163 11.1031 -355 2 0.721356 36.5788 2.57059 18.2386 -29.7925 23.2574 -356 3 54.9678 37.5551 2.63992 10.9193 3.0322 -8.68025 -357 4 3.31287 34.9586 1.40066 1.19836 -3.77239 4.28893 -358 4 2.05059 37.3327 0.922928 -11.4048 10.7741 9.22697 -359 2 1.07197 35.5705 0.158527 41.3495 -39.9506 -9.05678 -360 2 1.73776 35.9497 40.6674 -26.4234 39.8053 33.0301 -361 2 54.5322 35.7209 0.133627 -14.8072 -12.0564 -1.20894 -362 2 3.23928 35.9487 40.63 7.11928 -24.1756 -12.68 -363 4 1.32474 34.4514 0.269568 -7.211 20.0201 5.35532 -364 4 1.47926 37.0502 40.6385 -3.87579 -7.90549 -26.2729 -365 4 1.36122 35.3789 39.7771 -4.72819 3.84386 12.155 -366 4 54.087 35.0558 41.2526 3.68912 7.63158 3.17282 -367 4 54.2076 36.7772 41.8385 0.949253 -6.55132 4.09096 -368 4 54.0676 35.3362 1.10912 4.22691 12.456 -17.368 -369 4 3.57003 34.9443 40.8434 9.13412 -24.8126 8.40569 -370 4 3.78301 36.5792 41.3142 5.34684 18.5101 18.1918 -371 4 3.6567 36.127 39.6372 -0.20476 7.44967 -14.9904 -372 1 0.712989 35.6055 3.58431 38.0557 9.26554 -59.6495 -373 2 0.05279 35.6483 4.83915 -15.0961 2.42646 38.658 -374 2 0.191347 37.0144 5.48801 7.00468 33.8104 1.40802 -375 3 54.154 37.7008 5.76148 35.4113 -11.6645 -8.2681 -376 4 1.23482 34.733 3.35856 -11.2418 4.01634 10.8504 -377 4 53.9671 35.581 4.69172 -20.2496 -5.13772 -12.456 -378 2 0.463881 34.4895 5.81355 17.031 15.9659 -33.5139 -379 2 54.8083 34.3393 7.16558 -30.7527 -16.2072 -11.1445 -380 2 0.00712 35.4957 8.10271 3.59003 -8.69902 15.3198 -381 3 54.0967 36.3529 8.34542 -1.77732 -9.94333 -12.6544 -382 3 1.07192 35.4587 8.7399 35.3598 16.353 18.5034 -383 4 1.56574 34.5304 5.94519 0.590681 0.639559 4.32925 -384 4 0.280894 33.5741 5.23349 -1.52963 -16.3279 0.16603 -385 4 0.223173 33.3947 7.64873 -6.8885 8.42796 -3.46601 -386 4 53.7112 34.1554 6.97481 9.65493 -2.46487 7.60139 -387 1 1.50649 37.4152 5.65526 -22.458 -31.2308 -17.0045 -388 2 2.02438 38.6379 6.15097 -3.22056 29.1656 36.4104 -389 2 1.58588 39.8651 5.40701 -13.5031 20.9194 -76.104 -390 3 1.07209 40.8553 5.93778 8.03965 -15.1327 11.1864 -391 4 2.24702 36.741 5.38136 -6.00826 1.88497 2.51587 -392 4 1.72629 38.833 7.20228 -22.1923 -11.9073 0.0585309 -393 2 3.51949 38.6121 6.24971 43.6984 -50.5664 -0.0787057 -394 2 4.11017 39.7004 7.10642 -5.48661 12.2779 -12.8977 -395 3 4.55887 40.7033 6.57435 6.12607 11.2234 -5.55098 -396 1 3.97545 39.5562 8.42942 -13.6958 7.00999 41.6346 -397 4 3.92653 38.5973 5.19958 6.67843 9.43594 11.2804 -398 4 3.90699 37.6191 6.72902 -10.8805 23.4385 -12.7616 -399 4 3.35162 38.8096 8.83526 13.2612 9.60447 -6.60232 -400 4 4.25023 40.3377 9.09595 -2.56729 -20.1743 -21.9158 -401 1 1.64621 39.8034 3.99517 -50.1719 52.4074 67.8966 -402 2 0.960547 40.8538 3.14427 -3.37695 -31.9032 -17.009 -403 2 54.4047 41.0035 3.47138 71.1401 19.2662 2.3079 -404 3 53.9887 0.221409 3.63964 -22.8765 18.4333 9.81455 -405 4 2.07659 38.9926 3.63308 18.9969 -31.9912 -34.7926 -406 4 1.39808 41.8727 3.34889 0.835518 -9.01277 1.27119 -407 2 1.14841 40.4887 1.56595 -9.49555 20.2148 39.7014 -408 2 0.469253 41.6189 0.677094 10.8075 11.2475 47.495 -409 2 2.6528 40.4777 1.25625 -15.459 -47.3647 -39.6369 -410 4 0.776571 39.4398 1.40308 -11.1955 11.1351 -6.38222 -411 4 54.3852 41.8501 0.825468 -5.0709 -17.7069 -2.05205 -412 4 0.696071 41.5065 41.5456 0.0730393 -4.82529 -32.9133 -413 4 0.904174 0.691668 0.985463 6.30616 -9.41897 -5.2369 -414 4 2.64269 40.3122 0.13166 16.7998 18.1471 15.5753 -415 4 3.13789 39.5289 1.58622 -1.56816 4.1145 9.56394 -416 4 3.29805 41.2779 1.59825 6.1243 20.9887 1.16769 -417 1 53.684 39.9214 3.65257 -36.1976 13.6917 8.19643 -418 2 52.3006 39.9493 4.06589 -56.8626 -17.5359 -10.0305 -419 2 52.042 40.5256 5.46425 9.62461 10.2848 -5.14962 -420 3 51.0331 41.2228 5.70144 14.4944 -11.372 -4.23176 -421 4 54.0189 39.0607 3.30247 15.8062 -40.5534 -6.95561 -422 4 51.6931 40.6476 3.38276 19.0563 -8.07776 7.22418 -423 2 51.5622 38.4976 3.96193 14.5706 2.1127 21.5154 -424 2 51.4158 37.9814 2.50572 24.752 -20.928 -15.9835 -425 2 51.0077 36.4305 2.37064 11.3099 30.9145 9.08043 -426 2 50.8522 35.9939 0.907307 -46.4939 -7.09254 -49.7464 -427 1 50.1475 34.7025 0.671588 69.6077 -32.405 2.84717 -428 4 50.6006 38.4842 4.55016 3.73478 6.81079 -18.2086 -429 4 52.1831 37.7463 4.55262 -3.81101 12.3643 -13.1539 -430 4 52.4118 38.1657 2.02278 1.77015 -18.5404 7.48984 -431 4 50.8584 38.5927 1.79489 -26.3581 9.74254 8.34414 -432 4 50.0453 36.2246 2.88499 -2.56193 3.57961 3.68626 -433 4 51.7703 35.8375 2.92238 0.215708 -6.73604 -5.33103 -434 4 51.7691 36.0437 0.240386 -6.2594 -4.10885 19.6388 -435 4 50.1039 36.686 0.3716 22.9763 1.60597 16.3794 -436 4 50.5914 33.8993 1.10828 2.95648 12.8391 18.7814 -437 4 50.3001 34.3737 41.6268 -19.3387 19.3411 -4.27099 -438 4 49.2006 34.6111 0.961468 -24.084 7.88088 -0.582308 -439 1 53.0235 40.2561 6.35237 -32.3128 10.4579 -5.0201 -440 2 53.1129 40.7256 7.70074 -41.6363 -1.15369 57.3167 -441 2 53.1798 0.352689 7.77253 -34.9991 -20.8035 37.2736 -442 3 52.5119 1.01286 8.63006 21.7579 -17.6925 -30.8538 -443 4 53.6931 39.5673 6.06584 22.7894 -18.2937 1.39271 -444 4 52.0865 40.4844 8.3065 35.7608 3.68212 -29.1988 -445 2 54.2701 40.0034 8.46069 6.08948 28.5921 -6.02695 -446 4 54.5971 40.5153 9.39975 -22.234 -14.34 10.1754 -447 4 0.201561 40.2092 7.93116 13.6903 -2.08726 -21.3806 -448 4 54.1655 38.8939 8.41526 -0.559105 0.118215 15.5404 -449 1 53.9752 0.884949 6.87383 32.3465 35.364 -24.1241 -450 2 54.062 2.35993 6.75215 -1.13821 -0.709889 -34.8218 -451 2 52.7471 3.02097 6.14186 4.92946 35.4069 59.7439 -452 3 52.3227 4.16587 6.4978 18.9545 -33.4145 3.00952 -453 4 54.7345 0.266534 6.4753 -18.8262 24.4346 -1.05702 -454 4 54.2802 2.76759 7.79054 -12.1814 3.84369 -14.3249 -455 2 0.185451 2.81859 5.73187 27.2059 46.9588 30.4236 -456 2 1.71808 2.36893 6.1571 -63.9259 -20.0653 -29.4315 -457 2 1.9764 2.63004 7.63437 43.6306 13.7343 2.97159 -458 2 3.27263 1.81187 8.04275 -33.9139 -3.58936 -6.58926 -459 1 3.78328 2.11956 9.34176 26.6398 21.4152 24.507 -460 4 0.173809 4.01773 5.82442 4.54198 -39.0295 -6.50933 -461 4 54.8792 2.64498 4.65574 11.0791 -10.5686 10.592 -462 4 2.43618 2.90609 5.45978 -2.35628 -10.1976 10.4282 -463 4 1.76796 1.2289 6.01344 4.57023 21.5888 -8.89179 -464 4 1.21473 2.41369 8.37281 -19.449 -19.8593 5.28327 -465 4 2.02309 3.72579 7.75906 18.9296 5.96095 -1.30777 -466 4 4.11389 1.88412 7.33652 2.51142 0.584915 -8.00636 -467 4 2.91513 0.727469 8.06593 14.1612 11.4678 0.952909 -468 4 3.87966 1.33238 9.93849 2.65093 -23.7146 9.43734 -469 4 3.29203 2.7681 9.89323 -42.3935 13.6729 9.41431 -470 4 4.65765 2.6209 9.4154 12.4458 -11.5538 -21.8273 -471 1 52.0387 2.32512 5.28273 -51.3661 -11.8477 -11.6622 -472 2 50.6641 2.72274 4.84157 25.7857 6.93126 13.1254 -473 2 49.5414 2.57609 5.91007 27.6149 -7.37739 5.45836 -474 3 48.7805 3.52104 6.09585 -8.9672 -1.93713 4.87304 -475 4 52.4681 1.55108 4.79165 6.19099 -18.5603 -5.58783 -476 4 50.6769 3.82983 4.70864 1.41274 -1.50214 -10.3294 -477 2 50.3587 2.05695 3.49156 -22.4167 -18.5545 -8.10533 -478 2 51.392 2.35646 2.3419 -24.5199 12.8001 2.40788 -479 2 48.9327 2.41504 2.97856 -9.14079 -2.86031 26.3031 -480 2 51.1945 1.4129 1.15651 29.522 -13.6455 -15.5517 -481 4 50.3189 0.937191 3.7523 9.08136 15.4094 -11.3523 -482 4 52.3823 2.12188 2.68097 31.5971 -0.36407 15.4796 -483 4 51.4014 3.46798 2.06765 -1.078 -19.9026 -0.0406259 -484 4 48.2117 2.12758 3.78451 -1.04241 22.2186 2.00084 -485 4 48.5813 1.67256 2.28636 2.21501 -12.0529 -35.8697 -486 4 48.7327 3.44552 2.54328 5.48386 -12.5705 11.3103 -487 4 52.1623 1.3706 0.452926 -36.5132 5.61179 20.4585 -488 4 50.2881 1.70969 0.600596 -1.11419 -0.409473 -10.6314 -489 4 51.0211 0.353877 1.53511 3.53067 13.7442 -8.50616 -490 1 49.5623 1.51743 6.77214 29.0905 -0.0770965 -25.5222 -491 2 48.7084 1.41716 7.91723 -3.12505 -21.6463 4.96918 -492 2 48.8549 2.61932 8.82546 31.903 20.2748 29.0475 -493 3 47.906 3.05048 9.46897 -16.8524 2.35798 -10.3438 -494 4 50.2118 0.710522 6.59294 -12.9921 18.0739 4.61122 -495 4 47.6425 1.393 7.52359 9.91609 0.328738 10.372 -496 2 49.0787 0.089334 8.73016 -60.0302 -9.6098 -44.8862 -497 2 48.2852 41.7441 10.0242 3.18066 15.7764 -9.96769 -498 2 46.7826 0.060746 9.96682 -2.34726 -14.6607 41.7592 -499 3 46.2233 0.511631 10.9878 -5.96974 4.10403 -23.4495 -500 1 46.1388 41.3329 8.97776 32.9533 20.065 15.0282 -501 4 50.1182 0.035639 8.93296 42.8084 2.68407 12.3764 -502 4 48.8904 41.1121 8.0025 3.88899 17.9501 19.4277 -503 4 48.6104 0.602172 10.7954 4.73737 -18.8132 -0.914642 -504 4 48.4759 40.6816 10.3394 0.165969 9.19265 10.3013 -505 4 46.673 40.8953 8.25882 14.2049 -15.3063 -26.5369 -506 4 45.1569 41.364 8.91958 -49.0994 -2.53611 0.320683 -507 1 50.1114 3.13932 9.06291 -28.12 32.8195 0.337886 -508 2 50.3404 4.32895 9.98795 -1.65029 -57.226 -17.8628 -509 2 50.0322 5.66893 9.41362 -36.2334 -9.83443 -38.9072 -510 3 49.3598 6.44562 10.1062 15.3309 6.40082 -5.38514 -511 4 50.9085 2.84633 8.5071 12.3092 -10.0263 -3.45928 -512 4 49.5835 4.28149 10.7848 -3.38143 -13.253 14.1405 -513 2 51.7461 4.22789 10.5468 25.7206 14.4209 20.1557 -514 2 51.9023 5.17188 11.7283 -67.9962 -1.36338 64.1829 -515 3 50.9364 5.19004 12.6002 28.9599 1.18541 -41.9912 -516 3 52.9319 5.83594 11.9785 18.8411 2.87417 -24.5577 -517 4 52.4276 4.5214 9.72474 12.6887 -3.13287 0.413374 -518 4 52.058 3.21563 10.9647 -9.24198 7.66389 -16.6414 -519 1 50.112 5.78532 8.03139 7.52033 29.602 25.459 -520 2 49.6799 7.08933 7.40639 14.3534 -30.8181 22.5674 -521 2 48.2409 7.17209 6.9711 -2.24553 44.7474 7.57528 -522 3 47.5844 8.22961 7.08968 18.1939 -9.81929 5.41459 -523 4 50.7064 5.09112 7.53173 -12.638 14.3936 -6.22521 -524 4 49.7159 7.84119 8.19837 -7.36252 7.51614 21.2329 -525 2 50.7023 7.64954 6.44039 -16.0213 -40.4967 -48.4302 -526 2 50.7257 6.82423 5.08423 -13.7427 47.9405 2.4816 -527 2 51.6418 7.28287 3.94021 29.8472 39.248 73.299 -528 2 53.127 6.98483 4.24688 1.29977 19.7271 -18.9866 -529 1 53.757 7.95176 5.17575 -11.1866 13.844 -62.5277 -530 4 51.636 7.68275 6.97838 28.3767 1.23741 1.58475 -531 4 50.4129 8.66535 6.18803 -0.179632 23.7408 -3.11047 -532 4 49.7187 7.01043 4.64523 -5.97611 -10.1095 1.48316 -533 4 50.8061 5.7562 5.2149 3.4405 -22.8364 10.0865 -534 4 51.5118 8.41472 3.72654 -1.36136 -26.6124 -3.74792 -535 4 51.4228 6.66542 3.12568 -20.7249 -22.8033 -58.4365 -536 4 53.6095 7.03345 3.2004 3.85152 5.93338 28.8514 -537 4 53.3314 5.96083 4.57939 -0.112253 -9.13532 8.29834 -538 4 53.309 8.86524 5.1699 0.162268 -2.42959 1.84412 -539 4 54.6672 8.17057 4.81193 19.2107 -0.812718 7.6593 -540 4 53.869 7.69009 6.11536 0.991087 -15.435 33.6166 -541 1 47.7293 6.1299 6.36528 -13.6545 -50.1986 -45.913 -542 2 46.4151 6.11998 5.73127 12.5517 -4.35851 26.1033 -543 2 45.4457 5.24236 6.50095 -54.5114 -4.35957 -22.3583 -544 3 44.2134 5.34166 6.22856 33.5613 3.36987 15.344 -545 4 48.2957 5.29705 6.08439 -4.65701 16.0313 11.2062 -546 4 46.0246 7.14829 5.83676 -12.413 4.85954 -1.2939 -547 2 46.3966 5.7006 4.23247 16.9743 -35.0719 19.3242 -548 2 46.8471 6.79722 3.31369 7.95245 13.9142 -51.9109 -549 2 46.0679 8.12855 3.29075 19.7668 12.2354 20.4517 -550 3 44.9703 8.28242 2.6836 -5.20426 -7.76074 -7.99938 -551 3 46.5716 9.08042 3.9624 -5.49585 -3.27174 -8.75295 -552 4 45.3525 5.37075 3.98324 7.30106 1.55378 -6.68576 -553 4 47.1483 4.79199 4.10624 -28.8106 21.423 0.303262 -554 4 47.0017 6.41037 2.24023 -12.0684 6.13088 18.9752 -555 4 47.8815 7.05675 3.60692 6.175 4.12296 2.89493 -556 1 45.8802 4.28795 7.34048 -32.7588 9.8199 -6.22093 -557 2 44.9801 3.41661 8.05582 7.11941 -0.762777 6.83491 -558 2 44.2841 2.32798 7.24802 57.2007 25.2815 -35.4523 -559 3 43.4338 1.62321 7.71908 -38.784 -24.7635 26.1598 -560 4 46.8556 4.13399 7.46211 34.7056 -9.13536 7.69054 -561 4 45.5867 2.90913 8.82837 -2.10841 -5.06197 5.41207 -562 4 44.2233 4.00883 8.63057 1.71074 -0.990438 -6.10924 -563 1 44.7516 2.08483 5.98824 -37.8462 -38.4135 -8.16449 -564 2 44.1597 1.01431 5.13579 -9.65639 -34.378 14.28 -565 2 44.8664 41.5016 5.49089 -11.1964 37.9598 3.64882 -566 3 46.103 41.4369 5.57345 -11.1149 2.47206 2.88353 -567 4 45.5262 2.474 5.47152 21.0389 22.2918 12.8005 -568 4 43.0172 0.862184 5.40503 31.5022 14.6416 -15.142 -569 2 44.4162 1.4085 3.60515 5.8653 -21.2021 14.2009 -570 2 43.5161 2.65984 3.27425 41.0117 -18.0627 24.5931 -571 2 44.2213 0.116838 2.67583 -30.001 3.65408 12.6342 -572 2 43.604 3.10049 1.82796 -41.0466 14.5447 22.3036 -573 4 45.4923 1.71966 3.57573 -0.138156 -3.02814 -11.6903 -574 4 43.8008 3.50537 3.97163 -2.46499 -4.10631 -11.566 -575 4 42.524 2.38704 3.60859 -29.3388 -0.685173 -5.23931 -576 4 44.5714 0.285197 1.65031 -2.2735 9.46305 -11.1841 -577 4 43.1006 41.7553 2.65834 21.2852 6.7215 -5.00379 -578 4 44.7366 41.0658 2.93547 0.768749 11.7185 9.28335 -579 4 44.5004 3.68719 1.60884 14.6444 -0.878149 -7.94907 -580 4 42.7371 3.8089 1.73084 7.8177 -0.664582 -10.9353 -581 4 43.3892 2.25631 1.16493 5.07933 -5.28874 -15.8541 -582 1 44.0858 40.4147 5.76991 -7.82686 10.7063 0.0613705 -583 2 44.6952 39.2248 6.26612 46.8291 -49.1328 2.55503 -584 2 45.6273 38.4983 5.15014 -10.8203 -24.5871 -10.3389 -585 3 45.1671 38.1033 4.04814 1.93862 22.6196 32.2907 -586 4 45.3114 39.4262 7.20071 -5.62912 7.00222 -16.0196 -587 2 43.5561 38.2867 6.74046 -22.632 -0.869913 -14.9675 -588 2 42.367 38.8131 5.80069 8.99216 14.1028 58.1483 -589 2 42.6345 40.3137 5.92605 0.476166 33.3948 28.8915 -590 4 43.357 38.4284 7.8368 -6.62566 13.9326 -12.0425 -591 4 43.8048 37.1922 6.7609 -3.60965 9.48681 -21.6917 -592 4 41.3136 38.6254 6.13023 8.266 -9.51845 1.65532 -593 4 42.4187 38.6156 4.74928 6.70678 -23.3061 -29.6074 -594 4 42.2773 40.816 6.98347 15.1971 -23.3227 -46.4987 -595 4 42.1119 40.8277 5.08767 -3.55372 4.4917 2.49103 -596 1 46.8487 37.9967 5.55394 17.2019 12.2692 25.006 -597 2 47.7247 37.0178 4.87762 -6.21972 -16.2302 -28.9734 -598 2 47.0354 35.8358 4.10675 -5.54108 30.4574 49.2069 -599 3 47.4638 35.4602 3.01706 -3.2731 6.26074 0.626287 -600 4 48.411 37.4477 4.12082 -11.0175 18.1135 -5.68521 -601 2 48.6499 36.5231 5.98749 -16.6595 -15.0747 15.7963 -602 2 48.891 37.7945 6.79307 0.637735 -25.9659 35.4869 -603 2 47.512 38.4108 6.81936 -6.06228 0.364124 -35.7901 -604 4 49.55 36.0027 5.64818 14.2665 0.926908 -8.4052 -605 4 48.1323 35.7432 6.6035 -1.04051 5.39171 0.916503 -606 4 49.6303 38.4539 6.33816 11.9938 9.28906 -4.17289 -607 4 49.2156 37.5316 7.87598 -0.828426 8.45001 -24.626 -608 4 47.6223 39.5002 6.92189 -5.61966 10.135 -2.25063 -609 4 46.9349 38.0418 7.65693 -11.0214 -6.34351 22.8142 -610 1 45.9811 35.3016 4.79343 19.1712 31.3513 11.165 -611 2 45.3118 34.1769 4.28537 -21.2148 -46.3229 -17.5718 -612 2 44.4751 34.4561 3.06273 -18.3812 8.00009 -33.6438 -613 3 44.391 33.6426 2.09905 3.94034 16.0457 30.0851 -614 4 45.6176 35.6832 5.71813 13.2063 -8.66839 -22.6288 -615 4 46.0373 33.4799 3.80083 11.0255 -0.404913 12.3267 -616 2 44.604 33.4055 5.40679 37.9095 -5.49339 -20.8443 -617 2 43.894 32.1911 4.95963 4.52806 -52.0805 -10.2655 -618 3 42.6666 32.0496 5.30411 26.1406 -7.63566 -17.5185 -619 3 44.6473 31.2926 4.419 -30.7677 19.4747 14.2469 -620 4 43.8381 33.9821 5.82617 -35.1808 40.951 30.2942 -621 4 45.3664 33.1691 6.19311 -10.275 -1.0365 4.4818 -622 1 43.9409 35.7078 2.94042 3.22733 -51.5357 -49.9186 -623 2 43.348 36.2006 1.70588 25.8776 -9.12573 -18.8138 -624 2 44.3757 36.8172 0.713167 -7.64912 -13.2689 38.6134 -625 3 44.0628 36.9589 41.4508 -2.41529 3.02373 -15.0868 -626 4 43.9087 36.323 3.69682 4.46748 41.5024 48.5675 -627 4 43.0059 35.3045 1.0879 -7.34341 13.0696 15.3539 -628 2 42.2218 37.2049 1.98307 -32.8685 -0.904888 11.5727 -629 2 41.1062 36.5938 2.90711 22.5622 20.6064 -2.77479 -630 2 39.8757 37.4913 2.92488 9.99264 -5.47282 62.3883 -631 3 39.5847 37.9927 4.02645 -6.88693 1.84466 -13.34 -632 1 39.0832 37.5519 1.86835 -2.09978 -20.426 -31.5908 -633 4 41.7044 37.4782 1.02484 10.2081 4.13789 1.30545 -634 4 42.5649 38.1527 2.49808 3.34998 -7.04672 -12.996 -635 4 41.496 36.4873 3.97615 -8.32458 2.86238 -16.0656 -636 4 40.817 35.592 2.59085 -6.50381 -15.3028 -7.15704 -637 4 39.3467 37.1489 0.943045 -1.18671 2.30285 11.2704 -638 4 38.1024 37.7997 2.00291 -4.61511 13.1634 -1.5169 -639 1 45.5865 37.1913 1.18701 0.34656 3.48246 -50.9957 -640 2 46.5715 37.7193 0.263736 40.0587 13.4866 27.3297 -641 2 47.1476 36.6709 41.2495 -9.99518 -39.8037 -22.9547 -642 3 47.6611 35.6473 41.7682 -3.12622 19.3551 -24.5438 -643 4 45.9505 37.0475 2.10099 0.0710674 -6.02767 36.3056 -644 4 46.0766 38.4733 41.5789 -9.05589 19.6465 -18.4972 -645 2 47.8462 38.4064 1.04164 -24.5048 14.2529 -26.5929 -646 2 47.4036 39.6651 1.82888 -3.7708 6.53308 31.1421 -647 2 48.5926 40.4064 2.51341 13.2626 3.99863 -2.76696 -648 3 49.7104 40.5691 1.98441 -24.6046 -10.5895 -1.86534 -649 1 48.3407 40.8898 3.74779 29.4138 -3.81739 16.8938 -650 4 48.597 38.7482 0.246377 -8.81496 -5.86425 14.2737 -651 4 48.3893 37.7509 1.72975 1.66752 -15.4435 3.74234 -652 4 46.6019 39.4971 2.66308 23.3117 -7.11271 -27.0857 -653 4 46.9261 40.3559 1.12913 -3.21242 13.4997 -7.95635 -654 4 47.3907 40.9351 4.12169 -5.60594 2.69026 7.41827 -655 4 49.1659 41.1473 4.37984 -25.8317 -2.18268 -20.985 -656 1 47.0143 36.8241 39.8589 2.94896 -6.17569 33.9376 -657 2 47.6738 36.0506 38.8108 16.6825 -23.5637 34.6067 -658 2 48.454 37.0258 37.9695 9.24498 -19.2444 17.2828 -659 3 47.9734 37.5867 37.0249 -16.9661 22.5794 -32.933 -660 4 46.3407 37.4883 39.4677 -2.13376 9.43233 0.449621 -661 4 48.4374 35.3321 39.3605 -24.6855 17.1776 -23.0678 -662 2 46.6968 35.2528 37.909 -27.9143 -33.2437 25.7199 -663 2 46.039 33.9895 38.7043 9.93401 10.5983 7.56799 -664 2 46.87 32.6784 38.9289 23.0786 -0.450758 -24.5995 -665 1 47.7656 32.5928 40.0651 -0.0346617 67.7235 50.2506 -666 2 48.5337 31.5574 40.3699 -14.5633 -26.8579 -35.9878 -667 1 48.7282 30.552 39.4879 -2.05986 8.25564 18.106 -668 1 48.8872 31.3858 41.6213 -4.84512 27.348 -3.11289 -669 4 47.2327 34.8627 37.0058 -5.81127 5.13112 -1.60937 -670 4 45.8267 35.9464 37.6192 18.3744 -10.9215 -5.83414 -671 4 45.065 33.6697 38.178 15.3305 12.1509 10.6411 -672 4 45.8045 34.3704 39.7428 -14.1926 -3.74807 -10.9265 -673 4 47.5159 32.4832 38.0006 -21.4463 1.51143 8.96621 -674 4 46.1858 31.8178 39.0967 -9.12823 -0.449275 -15.1225 -675 4 47.7485 33.3794 40.8208 -8.02877 -26.8637 -33.9869 -676 4 48.3609 30.5297 38.5261 -2.43008 2.66571 1.08755 -677 4 49.1746 29.6933 39.8011 5.57148 -11.3344 1.43527 -678 4 48.5595 32.0107 0.447997 -4.49593 6.14729 8.57279 -679 4 49.3675 30.5632 41.8859 20.5825 -37.41 17.1512 -680 1 49.6971 37.2567 38.3612 38.8031 36.8466 -19.9315 -681 2 50.6251 38.1764 37.6375 5.59701 -6.58181 11.8605 -682 2 51.1059 37.476 36.33 -5.39593 -3.52342 3.95062 -683 3 51.4567 36.2851 36.3473 -6.1727 9.88097 2.62067 -684 4 50.1666 36.6257 38.9842 10.5469 -17.0261 18.2142 -685 4 50.0436 39.1015 37.4003 1.48542 -2.85918 -9.88003 -686 2 51.8783 38.6033 38.5414 -14.1699 17.2606 4.5582 -687 2 51.4771 39.4948 39.8067 23.634 -8.13025 9.13717 -688 2 52.8025 39.6936 40.6861 -45.72 0.0787629 30.9804 -689 2 51.0312 40.8873 39.3543 -1.21924 6.71403 17.5275 -690 4 52.6247 39.2003 37.9187 -12.0326 -10.2321 5.24388 -691 4 52.4336 37.7304 38.9418 -1.83231 -8.6555 -7.07863 -692 4 50.6844 38.9864 40.4458 6.67436 6.37453 -9.78056 -693 4 52.9275 38.7652 41.2899 1.57503 4.15297 5.5095 -694 4 52.875 40.6185 41.4124 -9.95772 -27.9304 -22.9777 -695 4 53.6477 39.6981 40.0479 39.2622 9.27083 -23.1198 -696 4 51.882 41.4315 38.8764 -8.78739 -1.58992 -12.4168 -697 4 50.8284 41.5065 40.2813 -10.0843 -5.65437 -12.2377 -698 4 50.1041 40.7893 38.7156 9.84678 12.7352 4.22225 -699 1 51.1335 38.2092 35.1872 23.4477 43.7196 -18.1994 -700 2 51.5372 37.7272 33.8205 5.66277 23.826 53.2621 -701 2 52.816 38.5373 33.39 -13.9696 27.2523 3.91394 -702 3 52.9014 39.7954 33.5824 -9.48934 -35.8428 -1.88315 -703 4 51.0917 39.2914 35.1751 -6.07189 -44.7564 8.7296 -704 4 51.807 36.6734 33.9114 3.67702 -17.8942 -3.77347 -705 2 50.2728 37.942 32.9627 24.5619 2.20768 -27.072 -706 2 49.0946 37.0552 33.3907 -40.4332 32.861 4.12747 -707 2 50.6582 37.6771 31.4819 -4.87136 -12.6088 -15.1928 -708 2 49.1924 35.592 33.2496 18.605 -47.1891 -10.6734 -709 4 50.0222 39.0181 33.0462 -10.0421 3.96713 0.824793 -710 4 48.1822 37.369 32.7965 11.3859 0.507389 5.43773 -711 4 48.766 37.227 34.4352 6.35082 10.8857 5.72377 -712 4 49.7261 37.457 30.8365 21.3715 9.42576 10.5226 -713 4 51.3528 36.7896 31.3856 -11.4398 6.26312 1.5823 -714 4 51.2274 38.5516 31.0485 -10.0605 -6.0953 1.35419 -715 4 50.1827 35.2313 33.6939 -19.2762 -1.86106 -7.31237 -716 4 49.1345 35.3223 32.1629 6.46074 -3.78635 4.92713 -717 4 48.3248 35.0641 33.7333 8.66481 1.90115 0.669024 -718 1 53.7674 37.8522 32.7049 -0.401058 29.0536 2.76503 -719 2 54.8534 38.494 31.9889 21.3589 25.2573 -50.7784 -720 2 0.070256 37.9331 30.5159 -12.6617 -10.513 26.1463 -721 3 0.610536 36.8336 30.3273 -13.153 9.14635 -3.0322 -722 4 53.7049 36.8532 32.6778 5.78014 -33.2974 -6.55066 -723 4 54.4976 39.583 31.7137 12.734 -24.0185 30.659 -724 2 1.32523 38.4582 32.6174 -11.2306 -14.0383 43.8112 -725 2 2.25298 39.4244 31.93 21.239 -3.52493 -6.53852 -726 2 1.82142 40.7594 31.946 9.01925 8.15494 1.3639 -727 2 3.55305 39.1373 31.3858 -52.1121 -37.4601 32.7366 -728 2 2.62719 41.7738 31.436 16.1375 42.966 -9.20235 -729 2 4.2717 40.1621 30.8907 55.019 31.5071 -38.7093 -730 2 3.8753 41.5182 30.8618 10.3374 -30.1635 6.5347 -731 4 1.72137 37.3957 32.6071 -2.968 13.2806 -7.3675 -732 4 1.36361 38.7573 33.7485 -10.0277 -6.08615 -32.1159 -733 4 0.900203 41.04 32.4671 -4.90014 4.47018 0.827909 -734 4 4.05865 38.1292 31.3848 -19.507 10.3261 2.47632 -735 4 2.40669 0.963664 31.507 -12.4107 -17.8541 2.52862 -736 4 5.22734 39.8163 30.4261 -2.17835 18.3508 4.41679 -737 4 4.61313 0.382875 30.4956 -18.9116 -9.53382 4.9162 -738 1 54.5208 38.7001 29.536 -17.794 9.59417 2.44526 -739 2 54.4433 38.3677 28.0932 0.413701 6.77287 11.8816 -740 2 53.8236 36.9714 27.8054 -10.5704 38.9519 24.3324 -741 3 54.2836 36.1684 27.0139 12.3723 -16.7122 -9.38408 -742 4 54.0063 39.582 29.8758 15.9225 -27.1932 -25.0825 -743 4 53.6617 39.0994 27.7122 21.1252 -9.31914 -10.5745 -744 2 0.84771 38.4562 27.3872 5.21129 26.4327 0.415045 -745 4 1.55752 39.2926 27.6564 -22.375 -0.429945 3.27523 -746 4 0.737328 38.5366 26.268 -0.662808 -7.52676 8.67249 -747 4 1.44048 37.5755 27.6711 3.3074 -14.1434 -6.0421 -748 1 52.6712 36.7812 28.4639 -34.4859 10.4254 42.9936 -749 2 51.8461 35.5981 28.5315 7.11639 -32.3641 19.2856 -750 2 52.1287 34.6607 29.761 72.1729 37.4894 -16.6197 -751 3 51.2969 33.8912 30.1393 -37.38 -39.1809 16.7772 -752 4 52.2301 37.5459 29.0797 18.7619 -22.9106 -24.882 -753 4 50.752 35.8045 28.6381 6.6344 10.4547 -3.03351 -754 4 51.9318 34.9661 27.6028 3.27123 7.03186 8.45077 -755 1 53.4041 34.6064 30.3039 -37.1524 -18.2668 23.7743 -756 2 53.8481 33.579 31.3343 19.9058 12.4048 -28.9308 -757 2 53.2753 33.7631 32.7245 -4.20442 17.2631 -10.7202 -758 3 53.3264 34.8931 33.2388 -7.00143 -11.8952 2.65621 -759 4 53.9984 35.4233 30.2821 14.046 11.4873 -9.55867 -760 4 53.5575 32.5679 30.9796 -2.97426 -3.20006 -4.3618 -761 2 0.441949 33.6673 31.397 15.483 24.485 -22.5221 -762 2 1.1159 33.1056 30.111 -2.52249 -22.0361 -11.2405 -763 2 2.65939 33.3504 30.0471 -29.7948 -11.8394 -36.8606 -764 2 3.5253 32.433 30.8659 3.71436 3.74322 35.9681 -765 1 4.92891 32.7835 30.8601 -3.73949 -14.6782 3.94495 -766 4 0.930008 33.1164 32.2052 -10.1795 -8.12889 21.2637 -767 4 0.820281 34.7554 31.5264 -17.1946 -20.5931 1.67355 -768 4 0.726808 33.5631 29.1693 -8.69229 5.5421 6.41341 -769 4 0.816642 32.0044 30.0112 14.0154 14.8269 0.94841 -770 4 2.76655 34.4177 30.2798 16.9839 11.3836 1.64388 -771 4 2.99027 33.2006 28.9712 -4.31169 8.16855 10.4317 -772 4 3.48024 31.3628 30.6286 -9.21502 -9.13385 -9.88849 -773 4 3.14214 32.5157 31.9169 10.307 -3.37241 -3.01155 -774 4 5.38024 32.7641 29.968 4.13535 -6.65161 -12.8027 -775 4 5.44585 32.16 31.4735 7.57437 4.94374 1.68638 -776 4 5.11721 33.7072 31.1652 -0.520286 24.3887 13.7994 -777 1 52.7286 32.6609 33.3217 21.3895 7.82715 -40.48 -778 2 52.3746 32.6765 34.6845 -3.94215 -5.7204 42.1903 -779 2 53.6544 32.9612 35.4718 -32.0777 16.7216 -3.31611 -780 3 54.7101 32.4293 35.2196 26.5529 -12.799 -1.69002 -781 4 52.7346 31.7402 32.8358 -3.66087 10.5856 2.03104 -782 4 51.6553 33.4893 34.886 -4.93781 11.2662 -7.45083 -783 2 51.7389 31.3462 35.1425 36.1525 -8.24878 -2.45066 -784 2 50.4549 31.4357 35.902 -2.56298 9.46411 57.003 -785 2 50.5914 31.9702 37.3969 -4.77582 -10.2539 -35.2763 -786 3 49.9129 32.941 37.7385 4.53321 10.1718 7.36032 -787 1 51.4448 31.3274 38.2318 1.89331 10.2207 20.9211 -788 4 52.4532 30.7011 35.7138 0.934865 4.72627 -2.3237 -789 4 51.5619 30.7887 34.2312 -11.1921 -21.1455 -14.7508 -790 4 50.0197 30.4197 36.0127 -8.03636 -0.273264 -6.56567 -791 4 49.7685 32.1089 35.3545 -11.9583 -2.57651 0.31815 -792 4 51.7323 30.3416 38.1022 2.22495 5.18328 -8.30147 -793 4 51.645 31.7871 39.1631 -4.2657 -12.8631 -21.1898 -794 1 53.54 33.8952 36.4131 -39.2018 -0.531466 -0.79929 -795 2 54.5682 34.2648 37.3102 -29.3437 58.7358 21.9421 -796 2 54.3255 33.5954 38.6431 29.6978 -77.406 0.637438 -797 3 53.3742 33.7807 39.3881 -15.8118 22.9548 5.85491 -798 4 52.6165 34.3686 36.5483 14.9252 -1.63515 2.31459 -799 4 0.525104 33.9954 36.8979 32.3496 -27.0675 -4.05845 -800 2 54.6285 35.827 37.4074 -17.7645 -17.3983 39.0191 -801 2 0.013954 36.4546 36.058 15.6745 -1.04323 18.583 -802 2 0.049019 37.9526 36.293 -63.1087 6.90888 -39.4544 -803 2 1.42802 35.9308 35.6826 4.08802 -6.56861 34.108 -804 4 0.435555 35.9801 38.2063 -13.4425 16.5914 -13.2273 -805 4 53.6198 36.2963 37.798 28.292 -21.2068 -7.80607 -806 4 54.2061 36.2134 35.3084 7.36084 -1.04605 -3.46995 -807 4 54.0713 38.2397 36.8522 27.1057 4.55429 -9.55418 -808 4 54.939 38.4282 35.2643 6.0019 1.58695 18.2366 -809 4 0.927863 38.3313 36.762 28.685 14.2218 21.5028 -810 4 1.30489 34.8989 35.3991 1.43296 -22.664 -21.4406 -811 4 2.25694 35.8344 36.4845 -24.5016 17.8738 -12.6534 -812 4 1.83634 36.4362 34.8335 13.635 15.7788 -26.8996 -813 1 0.008587 32.3758 38.733 13.7846 27.3237 -75.0314 -814 2 54.826 31.3 39.6331 17.4428 -14.6066 45.4768 -815 2 0.455793 31.7866 40.9725 -5.37526 1.66294 14.9859 -816 3 1.60943 32.1773 41.0547 11.2247 3.92934 -7.13086 -817 4 0.661532 32.0877 37.9163 -19.8505 19.9989 33.4434 -818 4 53.7452 31.1425 39.875 0.374502 -5.35979 -15.722 -819 2 0.574437 30.0043 39.0439 11.2157 23.6116 11.9724 -820 2 0.334302 28.7136 39.8578 -22.6665 -11.1233 -21.4622 -821 2 0.695999 28.7 41.3625 12.0844 -36.9796 9.0265 -822 3 54.7253 28.727 0.298109 10.889 15.3071 -4.11946 -823 3 1.91063 28.4506 41.7261 -30.7481 15.8042 -10.4483 -824 4 1.71086 30.1341 39.082 -19.7243 9.32222 0.312381 -825 4 0.358791 29.9926 37.9166 -2.62684 -19.8589 21.79 -826 4 0.882365 27.912 39.2891 -0.232785 0.308618 14.1734 -827 4 54.2301 28.3798 39.7718 17.2545 10.1943 -0.206185 -828 1 54.6325 31.7916 0.156881 38.5875 2.07504 -29.8841 -829 2 54.8631 32.3302 1.45975 7.41407 33.4343 26.7616 -830 2 1.21087 32.0241 2.20189 -33.1211 2.89979 -4.9396 -831 3 1.57835 32.811 3.08735 12.0797 -3.2377 -11.0832 -832 4 53.6756 31.6317 41.8616 -38.5912 -7.03962 0.740029 -833 4 54.9627 33.4927 1.3754 -11.7864 -35.033 -4.32612 -834 2 53.6666 32.0355 2.42828 -17.6969 8.95863 -1.18459 -835 2 52.1933 32.3158 2.0402 15.1012 41.0915 -15.9482 -836 3 51.3911 33.0513 2.74715 36.5037 -34.5123 -13.5772 -837 3 51.9207 32.0348 0.835441 -22.1157 -3.97518 6.29873 -838 4 53.9089 32.5595 3.33158 -2.01457 20.6007 30.7692 -839 4 53.6609 31.0051 2.75768 6.68313 -26.6133 3.27231 -840 1 1.77413 30.8239 1.99288 23.346 -11.0551 12.4557 -841 2 2.99412 30.3649 2.70859 20.7873 20.7026 2.58588 -842 2 4.37767 30.5585 1.9432 -4.58172 12.4342 76.2013 -843 3 5.43315 30.6356 2.6242 -17.4542 -1.84538 -14.1099 -844 4 1.23141 30.1158 1.49013 8.16278 -4.42375 -5.05013 -845 4 3.08709 30.9756 3.71749 -2.54673 -19.312 -31.0286 -846 4 2.99418 29.2776 2.99437 -11.6108 14.2547 -3.21828 -847 1 4.33484 30.73 0.643592 -44.4777 10.1896 -41.2897 -848 2 5.29878 31.2923 41.6537 25.3276 0.744315 3.96016 -849 2 5.54544 32.7486 0.121481 37.2819 -30.872 -27.7426 -850 3 4.68176 33.387 0.67546 -18.5336 28.2868 17.8008 -851 4 3.3891 30.7154 0.224796 5.58966 -1.49205 -0.51948 -852 4 6.30256 30.8588 41.8823 -3.47112 -15.4387 -8.82901 -853 2 4.8423 31.1802 40.1578 47.5835 -21.6785 -9.15502 -854 2 4.71332 29.7742 39.4637 -7.18766 34.2596 -8.85866 -855 2 5.63064 28.6968 40.0034 1.34917 -52.5839 -25.1875 -856 1 5.28494 28.1736 41.3081 -3.70672 3.58414 23.7744 -857 2 6.07557 28.0057 0.492928 -10.4577 4.69864 -29.3733 -858 1 7.37832 28.2278 0.392183 22.9004 -4.79637 26.256 -859 1 5.53705 27.6868 1.66636 -6.4094 -24.443 39.9026 -860 4 5.53303 31.787 39.5095 -0.196101 -2.7377 7.98036 -861 4 3.92152 31.7024 40.0755 -40.4143 20.5365 -6.7059 -862 4 4.89215 29.8961 38.3273 -2.53464 -0.592337 23.8175 -863 4 3.64677 29.4833 39.5295 -2.27017 -8.63927 2.61329 -864 4 6.69627 28.939 39.9328 9.42975 10.3347 -2.35439 -865 4 5.48992 27.7969 39.2806 7.04825 21.6687 20.0754 -866 4 4.27254 28.0467 41.4152 -4.83075 -3.28587 3.65899 -867 4 7.98538 28.2099 41.4852 -8.02405 3.18538 -21.0185 -868 4 7.94047 28.2423 1.24565 0.364194 -0.98827 11.7246 -869 4 4.53186 27.4078 1.78766 14.7644 10.3007 -8.4097 -870 4 6.1013 27.52 2.55737 -8.44391 7.70178 -27.0297 -871 1 6.79596 33.2006 41.6804 -27.9344 8.59735 4.57792 -872 2 7.15148 34.5952 41.8655 -38.9276 -12.1291 -1.68573 -873 2 6.77215 35.2911 40.5652 14.0197 56.9428 51.8707 -874 3 6.49158 34.715 39.5569 -13.5951 -21.5425 -43.0675 -875 4 7.31858 32.7386 40.9072 -2.655 4.76346 14.1821 -876 4 6.52583 35.0505 0.829338 19.3934 -10.3795 -24.0216 -877 2 8.63545 34.7883 0.159249 -4.7809 22.3707 74.7553 -878 3 9.31911 34.1951 41.0459 32.4158 -10.9375 -20.7672 -879 2 9.12239 34.1481 1.54228 -45.3508 12.3646 -39.5443 -880 4 8.86138 35.9031 0.177513 1.59938 -13.4643 1.18346 -881 4 10.1943 34.4871 41.2598 15.0836 -7.29109 -20.5697 -882 4 10.1218 34.4779 1.7295 32.9793 8.82002 13.7556 -883 4 9.1354 33.0404 1.45915 -3.89828 -1.77159 7.54964 -884 4 8.44695 34.5279 2.36236 9.39315 -9.78399 0.0431608 -885 1 6.96309 36.6454 40.6555 -22.2962 -38.3404 -33.8498 -886 2 6.94214 37.5275 39.5132 -15.3576 22.9899 27.1878 -887 2 8.03225 37.1821 38.5547 25.8315 2.87875 -39.3086 -888 3 7.87409 37.2091 37.3037 -11.7489 -2.94068 30.2829 -889 4 7.09017 37.0079 41.5812 4.58243 22.402 24.7274 -890 4 6.01646 37.4072 38.9238 -6.0018 -8.28766 -1.15408 -891 2 7.01182 39.0163 40.0252 -15.3603 -23.3284 55.3652 -892 2 5.61926 39.5384 40.7634 13.0639 11.727 -14.3013 -893 2 5.74741 41.0778 41.0735 34.612 -8.65688 -61.1535 -894 2 4.30485 39.278 39.9775 33.2171 6.29002 -24.4772 -895 4 7.23253 39.6079 39.1676 9.01238 29.648 -28.6912 -896 4 7.91826 39.1206 40.7867 -28.368 0.120823 -25.2036 -897 4 5.4532 38.9933 41.7239 13.5286 -1.18368 4.70417 -898 4 4.88701 41.4539 41.5866 -22.2749 9.39049 21.0562 -899 4 5.89633 41.7578 40.1185 -8.19165 -26.548 25.276 -900 4 6.67066 41.2365 41.6556 -0.494064 4.57358 11.7906 -901 4 4.18164 39.8273 38.9933 8.48456 -7.17755 11.4037 -902 4 3.44244 39.5261 40.5797 -17.807 1.17877 7.97341 -903 4 4.2824 38.1939 39.7929 -10.4691 -3.8299 -8.01616 -904 1 9.23783 36.8543 39.0653 -4.40645 21.0053 19.4908 -905 2 10.3275 36.5838 38.1582 31.0816 -25.3995 62.8998 -906 2 10.2997 35.2224 37.4613 6.04581 38.1949 -0.210763 -907 3 11.0208 35.1071 36.4655 -6.3656 -14.3958 -11.0193 -908 4 9.51333 37.1441 40.0706 -14.9717 -14.5173 -38.8343 -909 4 10.386 37.3498 37.3821 -1.67567 12.3369 -13.0834 -910 2 11.6168 36.6846 39.0604 -5.3878 -32.5356 -23.0633 -911 3 11.6818 35.7254 40.0985 -18.2206 13.507 16.8431 -912 4 11.7318 37.6647 39.5052 6.99822 20.9023 2.76215 -913 4 12.4798 36.426 38.4299 12.1644 16.7594 -11.1747 -914 4 12.2479 35.0511 39.7675 10.0745 -20.8981 -3.76732 -915 1 9.3909 34.3264 37.8733 -42.427 -15.3638 26.6935 -916 2 8.99216 33.1557 37.0842 54.1918 17.4661 1.85655 -917 2 8.44195 33.5842 35.7305 -20.833 60.571 55.2199 -918 3 8.45395 32.8337 34.8033 7.91235 -41.3122 -40.5547 -919 4 8.901 34.4208 38.8182 18.72 -3.57692 -25.7233 -920 4 10.0039 32.69 36.8915 -15.1884 -12.4868 -9.34361 -921 2 8.05349 32.1507 37.7268 -1.844 -26.1592 7.76215 -922 2 8.63612 31.2276 38.7905 8.98886 15.2457 3.52798 -923 3 8.28567 31.4376 39.9878 9.18033 -14.5703 -9.08999 -924 3 9.46172 30.3301 38.4185 -14.4281 10.7169 -2.66077 -925 4 7.57008 31.4717 36.9797 -4.32683 11.3708 2.99534 -926 4 7.24557 32.7088 38.1955 -18.7592 7.98312 4.87833 -927 1 7.76821 34.7903 35.7104 -0.921577 -49.5867 -7.77983 -928 2 7.00589 35.2713 34.5947 28.4194 33.7396 -49.4054 -929 2 7.85162 36.3274 33.7967 14.0615 10.3677 50.876 -930 3 7.59561 36.677 32.642 -11.5138 -12.0529 -0.0837023 -931 4 7.64044 35.3156 36.5601 -2.79577 12.0246 16.4277 -932 4 6.95142 34.464 33.8059 -8.74679 1.13416 10.6726 -933 2 5.60472 35.8897 34.9384 -10.82 -34.5279 -29.2679 -934 2 4.80808 34.6511 35.4252 21.4048 19.1212 -24.4535 -935 2 4.58939 34.449 36.7896 -8.79739 7.49237 6.99756 -936 2 4.44707 33.6361 34.4808 -22.1156 13.6667 13.0483 -937 2 3.78406 33.375 37.155 10.056 16.8174 60.0349 -938 2 3.57928 32.5992 34.8543 35.6828 20.067 14.4288 -939 2 3.32606 32.5122 36.2195 -36.4887 -32.5961 -12.2866 -940 3 2.43989 31.6229 36.7148 -5.7594 -17.052 -20.0699 -941 4 5.14192 36.3424 33.9886 5.39246 -18.3577 14.2305 -942 4 5.60606 36.7583 35.5989 7.01287 1.52307 19.367 -943 4 4.94491 35.1783 37.5598 -4.47364 -7.92921 -7.91861 -944 4 4.66046 33.7427 33.4202 4.87397 4.4658 -8.40916 -945 4 3.45738 33.1597 38.2449 15.2806 17.1295 -26.8514 -946 4 3.26795 31.828 34.148 -6.61111 -3.61155 -4.72788 -947 4 2.1868 31.1622 35.9134 -6.91994 -9.03483 11.406 -948 1 8.90205 36.8981 34.5027 -17.2687 17.5401 -60.9896 -949 2 9.70361 38.0134 33.9387 24.2231 -52.0812 37.3823 -950 2 8.8546 39.1711 33.5701 14.7092 18.0593 -4.53516 -951 3 9.06515 39.7643 32.526 6.45085 3.58457 -7.26619 -952 4 9.11675 36.6435 35.4518 3.62665 -3.0608 21.1339 -953 4 10.3861 38.3235 34.818 -10.2978 3.44266 -21.7419 -954 2 10.5787 37.5562 32.7307 -21.6135 -30.8037 4.74181 -955 2 11.6892 38.5091 32.4223 15.379 -13.1594 38.9153 -956 3 11.683 39.1804 31.4042 4.19267 20.0472 -18.4805 -957 1 12.6852 38.53 33.3751 41.3863 26.0224 -13.8263 -958 4 9.85905 37.4261 31.8504 20.0453 2.40541 7.8736 -959 4 11.053 36.5467 32.9319 -7.17885 8.97611 -4.2567 -960 4 12.817 37.8369 34.166 -15.4043 12.1891 -16.4176 -961 4 13.5001 39.2408 33.2564 -39.0039 -25.8302 4.81098 -962 1 7.96197 39.5631 34.4599 -33.9246 23.5433 37.1278 -963 2 7.21007 40.8276 34.5568 -18.3646 -15.2096 -14.7898 -964 2 8.22007 41.896 34.9201 0.758716 14.3361 -6.26955 -965 3 8.97663 41.7874 35.871 13.0919 -8.40756 13.8683 -966 4 7.83943 39.0508 35.3409 8.95409 -9.59767 0.690263 -967 4 6.70734 41.0591 33.5261 17.9743 -2.28149 22.8597 -968 2 6.0301 40.6247 35.6674 21.3841 11.5647 -11.8815 -969 2 4.89974 39.9794 34.8247 17.8968 2.41192 -27.2216 -970 2 5.64567 41.9074 36.4174 -5.31946 16.9228 -22.0167 -971 2 3.85064 39.271 35.6143 -7.9417 -14.8054 48.1955 -972 4 6.41951 40.0018 36.4929 2.02391 -20.04 -2.41117 -973 4 5.36435 39.2019 34.126 -8.73918 7.93575 11.5905 -974 4 4.48342 40.7424 34.1094 -6.00744 -5.42447 8.5897 -975 4 5.00487 41.8434 37.3074 -11.5574 -14.3762 1.01334 -976 4 5.12929 0.689353 35.6946 7.17582 1.37977 8.89479 -977 4 6.56067 0.460605 36.8355 2.18467 8.54142 -3.2903 -978 4 3.23423 39.9796 36.2601 8.91814 -10.815 -11.4927 -979 4 4.38489 38.5352 36.333 -17.3309 14.265 -14.1697 -980 4 3.16246 38.6765 34.9814 -1.3822 0.0882741 -1.23744 -981 1 8.27901 1.09677 34.1745 -17.8694 -35.8502 15.8719 -982 2 9.1495 2.17731 34.4611 25.5007 24.1899 -15.5427 -983 2 8.44305 3.45517 34.8181 7.33507 13.3767 -14.0082 -984 3 7.22584 3.58853 34.5952 14.73 6.44535 13.4701 -985 4 7.64387 1.07834 33.3925 -5.10967 17.8437 -25.4682 -986 4 9.72616 1.98981 35.3795 6.67437 -11.367 8.50474 -987 2 10.1416 2.3939 33.2727 7.80857 1.28792 -5.65283 -988 2 11.1754 1.27875 33.0535 -29.5709 -1.62172 8.74553 -989 2 12.298 1.25902 34.0434 45.8123 -20.4226 -15.8942 -990 3 13.4264 1.60062 33.6211 -9.09849 2.20405 14.6225 -991 1 12.1286 0.499484 35.1615 13.5856 38.0862 1.93866 -992 4 10.7117 3.33658 33.4062 0.0269402 1.80508 0.780117 -993 4 9.62868 2.54332 32.3022 -11.3844 1.67988 3.84081 -994 4 11.6026 1.39089 32.0291 1.1132 -6.32648 1.88738 -995 4 10.6463 0.304077 33.1517 4.80745 -4.48978 -13.057 -996 4 11.1623 0.324257 35.4356 -7.1112 -9.24345 12.7946 -997 4 12.86 0.645961 35.8984 -11.3978 -13.87 -11.7385 -998 1 9.29061 4.442 35.2624 -22.3208 40.9019 24.8252 -999 2 8.81116 5.82611 35.6978 -18.3987 -9.60009 -41.1421 -1000 2 7.90959 6.36535 34.5148 35.1086 -14.4229 -13.6713 -1001 3 8.27789 6.14754 33.3333 -13.6173 9.04219 21.6414 -1002 4 10.326 4.35425 35.3433 -15.5473 -10.8229 -5.10085 -1003 4 8.07437 5.70026 36.5174 9.02025 -1.47766 10.124 -1004 2 9.99583 6.76313 36.1565 -25.1565 20.6308 -28.9867 -1005 2 11.135 6.93617 35.1361 2.62363 -10.5046 6.46017 -1006 2 12.4502 7.42969 35.8581 -25.4448 -27.2564 -27.4451 -1007 2 12.3858 8.85842 36.3442 -55.084 26.5775 24.6628 -1008 1 13.634 9.41318 36.7712 33.8844 -44.8334 11.878 -1009 4 10.2929 6.30703 37.0832 24.0012 -1.96783 25.2264 -1010 4 9.73373 7.84957 36.4159 -14.1304 -26.7275 0.147522 -1011 4 10.8081 7.68154 34.3572 5.16283 -4.02502 4.78839 -1012 4 11.298 5.9636 34.5725 5.23915 16.0099 8.41141 -1013 4 13.159 7.4137 35.035 25.5516 -2.14082 -10.0364 -1014 4 12.8083 6.68649 36.6117 -1.06896 6.08822 -0.205097 -1015 4 11.642 8.94716 37.2538 22.1051 -1.45756 -27.4817 -1016 4 11.9592 9.50431 35.5025 9.97141 -3.64215 15.7788 -1017 4 13.6538 10.3723 37.0555 -8.09423 13.3796 3.79584 -1018 4 14.2885 9.3339 36.0056 2.60625 13.8446 -5.44478 -1019 4 14.0928 8.83644 37.5176 -15.06 24.3666 -13.6607 -1020 1 6.73429 6.959 34.8261 9.36917 -0.537504 -3.37326 -1021 2 5.68914 7.48312 33.9811 -11.6093 0.198368 -29.7566 -1022 2 4.72257 6.43001 33.3633 23.9678 57.8121 29.6097 -1023 3 3.69345 6.80336 32.8731 -41.5354 18.269 -25.9458 -1024 4 6.5403 7.08067 35.8075 -8.4584 6.57489 23.7637 -1025 4 4.95828 8.08289 34.6274 18.5559 -1.63885 -10.0577 -1026 2 6.30301 8.33887 32.7628 1.61604 -0.894199 46.3222 -1027 2 6.96232 9.68302 33.2113 17.5203 -12.0258 -13.4607 -1028 2 6.11334 10.8061 33.8152 -7.60378 12.6352 19.0416 -1029 3 5.31496 11.4419 33.0422 10.0378 -5.26853 5.86857 -1030 3 6.28181 11.1536 35.05 3.36103 -18.7342 -31.8229 -1031 4 5.5011 8.60814 32.0808 -13.4162 -1.3456 -15.0867 -1032 4 7.01778 7.64283 32.2215 -8.51236 18.4517 -1.11608 -1033 4 7.483 10.1113 32.3225 -5.01151 2.49106 -4.14977 -1034 4 7.84021 9.44334 33.8428 -3.17944 -2.15711 8.7111 -1035 1 4.98957 5.17145 33.408 31.7294 -73.5208 5.3031 -1036 2 4.03057 4.12888 32.9492 20.6717 -14.7005 -20.2168 -1037 2 2.6598 4.36206 33.592 -3.0444 -3.65398 -36.823 -1038 3 2.63368 4.6245 34.7729 -17.9957 9.5377 28.5993 -1039 4 5.93287 4.88555 33.7778 -25.4301 -4.21673 -10.3446 -1040 4 3.97065 4.08898 31.7849 -0.621936 10.7688 28.6704 -1041 2 4.54797 2.73693 33.4323 -9.78314 13.2989 35.3654 -1042 3 5.7396 2.38581 32.8061 3.87836 -1.00687 -28.9834 -1043 4 3.83029 1.94659 33.1597 -9.96533 -6.0451 7.8725 -1044 4 4.7579 2.77573 34.5879 -14.8326 -6.64015 -28.538 -1045 4 6.39905 2.57303 33.4496 16.1931 5.10903 8.49462 -1046 1 1.55493 4.20465 32.7937 9.73391 7.12296 -2.26043 -1047 2 0.143907 4.28394 33.2313 13.768 -18.1657 13.0528 -1048 2 54.6863 2.83094 33.3214 -0.0746788 -18.1404 42.9803 -1049 3 54.7972 2.04898 32.3833 -5.36381 -6.57018 -20.4337 -1050 4 1.75536 3.84626 31.8337 -17.5999 5.97734 12.9737 -1051 4 0.145346 4.72929 34.2869 -5.52407 -1.41906 -16.7638 -1052 2 54.0936 4.99047 32.3072 48.5491 53.4262 27.9832 -1053 3 54.4431 6.39026 32.3568 26.5828 -36.1107 8.98461 -1054 2 52.7233 5.01429 32.8691 -55.1486 3.23885 2.70228 -1055 4 54.1505 4.66496 31.2868 0.0550865 -16.0071 -29.7017 -1056 4 53.7986 6.85268 31.88 -20.6445 25.8891 -20.893 -1057 4 52.6197 5.54793 33.8322 5.93951 -5.3567 9.34144 -1058 4 52.3467 3.98503 32.9647 -9.06602 -5.34833 4.63236 -1059 4 51.9747 5.55452 32.2255 9.49609 -7.51028 -3.22615 -1060 1 54.1802 2.39741 34.5222 -14.8232 32.9081 27.5353 -1061 2 53.4465 1.14651 34.785 33.9277 15.1 -62.0226 -1062 2 52 1.44639 34.4384 -40.9452 -8.29472 -14.3346 -1063 3 51.516 2.52365 34.8247 -1.26544 -9.47139 -8.9244 -1064 4 54.0715 3.07846 35.3501 9.6448 -17.4772 -31.2652 -1065 4 53.9076 0.391021 34.1043 -10.2836 -7.20705 -0.475865 -1066 2 53.6069 0.737389 36.2058 40.6624 3.41232 47.0409 -1067 2 0.15698 0.778637 36.8849 -22.9225 14.5477 7.59965 -1068 2 0.184063 0.045177 38.2545 -1.48959 -18.0819 6.68284 -1069 2 1.19764 0.213126 35.924 -17.0247 17.4527 -16.4279 -1070 4 53.1759 41.6554 36.3315 -4.28574 -19.6707 2.88188 -1071 4 52.9166 1.40322 36.7387 0.80484 4.57892 22.2756 -1072 4 0.570353 1.84035 37.1024 -27.1105 -11.6335 -5.02718 -1073 4 54.3756 0.329349 38.9832 1.77724 8.98271 -8.45905 -1074 4 1.16626 0.241414 38.7954 -11.8595 -7.79047 -8.4361 -1075 4 0.0237 40.841 38.1265 8.8292 11.305 -0.869273 -1076 4 2.1582 0.044818 36.439 11.171 3.86438 -4.7836 -1077 4 1.22244 1.0066 35.1406 25.1303 -1.4606 -0.0516333 -1078 4 0.965216 41.2564 35.3038 -8.75588 -20.9773 6.66787 -1079 1 51.2089 0.49816 33.7614 57.6433 8.13256 28.0245 -1080 2 49.794 0.627079 33.5149 3.58551 37.6409 23.5907 -1081 2 49.1504 41.7362 34.5845 -39.3958 -31.0429 53.6988 -1082 3 49.3072 40.5133 34.7023 12.9245 12.8492 -11.6005 -1083 4 51.5663 41.4343 33.8516 -6.054 3.49016 -14.1934 -1084 4 49.5236 1.72635 33.6347 -1.89472 -11.9516 -1.26615 -1085 2 49.2899 0.093076 32.2111 -20.0469 10.239 -57.1496 -1086 2 49.5504 1.0758 31.0546 44.1484 5.96661 -35.419 -1087 1 48.7105 2.02971 30.4517 -2.34523 -25.3315 39.2373 -1088 2 50.7977 1.22066 30.3277 -75.7848 7.88288 4.96893 -1089 2 49.299 2.59293 29.3763 -23.865 8.39496 11.0232 -1090 1 50.5677 2.14293 29.3127 -12.36 -15.4034 27.3398 -1091 4 48.1533 41.8436 32.187 18.4481 1.21563 9.00361 -1092 4 49.725 40.9798 32.0543 -2.35302 7.24771 -7.56512 -1093 4 47.7373 2.26457 30.8018 19.6426 -7.09987 -8.69392 -1094 4 51.6402 0.582035 30.3922 15.3203 -1.97636 0.19948 -1095 4 48.6832 3.25559 28.7541 24.649 -5.28154 -1.94766 -1096 4 51.2124 2.39582 28.5799 18.4236 6.97779 -14.3308 -1097 1 48.3633 0.438016 35.503 -1.69139 30.1001 11.6909 -1098 2 47.6687 41.7006 36.6492 0.613805 18.6924 -40.9612 -1099 2 46.264 41.3694 36.1307 -7.02361 -30.4834 5.87484 -1100 3 45.3463 0.246853 35.8895 18.8914 5.06283 8.3795 -1101 4 48.1281 1.45816 35.4039 5.5506 -16.4063 -0.101422 -1102 4 48.2062 40.7837 36.9784 6.36967 -2.21031 -8.42979 -1103 2 47.5958 0.687745 37.8565 -25.4558 59.2473 29.5222 -1104 2 46.6931 0.064749 39.0402 -2.78345 4.00632 18.8053 -1105 2 47.0383 40.4557 39.4221 -33.2538 18.6268 -20.4936 -1106 2 46.93 0.927044 40.3419 31.4794 -11.2994 1.29194 -1107 4 47.1354 1.76149 37.5629 9.48386 -42.5729 7.15928 -1108 4 48.6298 0.997945 38.2155 -14.6806 -19.3715 -2.98409 -1109 4 45.5391 0.148422 38.8474 30.3772 -4.98305 -7.99897 -1110 4 47.9695 40.2725 39.9165 32.6255 3.33763 11.188 -1111 4 46.9967 39.7545 38.5575 0.158611 5.44488 0.559019 -1112 4 46.2719 40.0836 40.1333 -2.82757 0.291607 -0.331179 -1113 4 48.0832 1.04093 40.5802 -35.3824 -1.71169 -8.39188 -1114 4 46.4823 0.388091 41.2333 0.118939 13.4124 -7.57083 -1115 4 46.4764 1.95182 40.2253 3.79994 -8.06745 5.67231 -1116 1 46.1155 40.0363 35.9994 32.2071 3.49142 -20.6914 -1117 2 44.9353 39.2817 35.7114 0.014229 -40.6503 61.2515 -1118 2 44.4179 38.8949 37.157 4.06758 -27.6469 18.473 -1119 3 45.1574 38.4668 38.0935 -15.0116 19.769 -34.2637 -1120 4 46.9934 39.487 36.0733 -14.8983 -9.5139 0.794979 -1121 4 44.1193 39.9156 35.4266 -15.9448 22.0113 -37.9939 -1122 2 45.2307 37.9502 34.8403 3.73878 29.7444 42.1248 -1123 2 44.043 37.0324 34.841 -52.9272 -13.7306 14.9234 -1124 2 45.6185 38.368 33.4399 7.42128 1.51593 -38.9882 -1125 4 46.0406 37.394 35.3664 8.69137 1.61483 -3.86581 -1126 4 43.4486 36.945 35.811 20.0159 3.18287 -12.2628 -1127 4 44.3645 35.9957 34.6605 0.118723 -8.68919 -11.9568 -1128 4 43.2413 37.3473 34.1301 7.80666 -3.9283 -7.25571 -1129 4 46.619 38.86 33.4411 -0.357581 -2.40345 0.816384 -1130 4 44.931 39.1517 33.0584 -3.3954 -0.0150932 -1.42103 -1131 4 45.65 37.5606 32.6192 -0.759822 9.78394 24.304 -1132 1 43.0637 38.9039 37.3301 16.2039 -1.11298 52.5829 -1133 2 42.3901 38.4825 38.6382 8.13363 32.9232 -36.228 -1134 2 41.8706 37.0909 38.467 10.8397 -12.8704 71.8875 -1135 3 41.4837 36.7016 37.4073 -23.2793 -18.8499 -56.9312 -1136 4 42.5052 38.9697 36.5072 -31.8536 4.61581 -21.2592 -1137 4 43.1805 38.4127 39.3754 18.2924 -0.774441 22.1039 -1138 2 41.3003 39.5089 39.1545 11.9555 -3.56475 0.849013 -1139 2 41.9844 40.8891 39.6202 11.8289 -38.672 35.4909 -1140 2 41.1032 0.170603 39.4187 0.299182 35.0028 -21.1028 -1141 2 42.4599 40.8175 41.1074 30.4283 -6.43954 -3.58257 -1142 4 40.7378 39.0113 40.0259 3.55617 13.764 -16.8053 -1143 4 40.5882 39.6834 38.2893 4.7664 -2.44084 15.6093 -1144 4 42.9174 41.0251 39.0897 16.4872 7.11459 -27.4623 -1145 4 41.5448 1.21778 39.6878 -5.64292 -30.3916 -9.38981 -1146 4 40.1969 0.063548 40.0003 -21.2204 -0.202137 11.1399 -1147 4 40.8028 0.152067 38.3319 -0.566182 12.1591 9.51378 -1148 4 41.6814 40.5448 41.8308 -8.42244 -8.91154 4.32363 -1149 4 42.887 41.7652 41.4977 -6.37808 7.37928 -6.87517 -1150 4 43.378 40.1338 41.1957 -24.337 0.845851 0.000130478 -1151 1 41.833 36.287 39.5864 -11.7269 -9.12911 -32.1296 -1152 2 41.2021 34.942 39.6247 -13.3362 -7.3841 -33.9439 -1153 2 39.8438 35.1095 40.3167 -2.23182 -18.8086 0.488263 -1154 3 39.8319 35.4679 41.5133 -14.6884 5.15074 -23.9167 -1155 4 42.1857 36.6275 40.4819 6.41783 1.01312 8.70708 -1156 4 41.0734 34.4248 38.4971 0.391294 34.8961 43.783 -1157 2 42.0436 33.9307 40.4129 10.4134 -33.9193 29.8386 -1158 2 41.3224 32.6645 41.0046 18.9395 -8.84266 -15.0635 -1159 2 42.1741 31.41 41.1086 26.4224 -37.0889 -5.20117 -1160 1 43.3231 31.527 0.12404 8.16009 54.2467 4.49909 -1161 2 44.392 30.7336 0.312631 -11.8213 -13.5239 -25.8004 -1162 1 44.683 29.6211 41.5456 -0.875823 -13.5136 -9.93246 -1163 1 45.3567 31.1357 1.10637 -40.5913 52.4111 16.4216 -1164 4 42.6035 34.3028 41.3288 -3.49471 12.9719 -23.3931 -1165 4 42.7742 33.539 39.6653 10.0701 4.50298 5.32726 -1166 4 40.5106 32.3417 40.3808 -25.7726 1.2565 -24.6898 -1167 4 40.8602 32.7415 0.05618 -15.4481 23.3498 31.3369 -1168 4 42.5775 31.2408 40.0556 -4.97325 -9.97334 14.9806 -1169 4 41.5239 30.4863 41.4302 18.1675 25.5375 -11.7586 -1170 4 43.4773 32.5278 0.495625 -12.2609 -36.3484 -6.98406 -1171 4 44.1847 29.2591 40.6938 -0.904676 10.2844 18.7349 -1172 4 45.5197 29.0942 41.8602 -5.70345 -5.08504 -8.10101 -1173 4 45.1981 31.9946 1.67722 9.89922 -9.52065 -4.53153 -1174 4 46.1063 30.5613 1.39407 36.7186 -26.409 10.0907 -1175 1 38.7328 34.6894 39.6013 4.46457 11.7984 -0.102478 -1176 2 37.3765 34.7683 40.1611 -21.3466 -3.56213 -4.53749 -1177 2 37.2086 33.6902 41.246 35.3807 -34.3386 -58.3615 -1178 3 37.7056 32.5617 40.9531 -12.3371 14.3328 36.9617 -1179 4 38.7903 34.2139 38.6548 1.70782 19.6852 25.699 -1180 4 37.2103 35.7436 40.6571 5.74575 10.1154 -0.0963519 -1181 2 36.2415 34.546 39.0669 -3.18027 -0.0437456 15.212 -1182 2 36.1408 35.6492 37.9204 39.4301 -27.8538 10.4422 -1183 2 35.3755 35.0392 36.7616 2.61616 7.91146 -44.6699 -1184 2 35.4893 36.9279 38.4153 -43.6456 26.6605 -35.0263 -1185 4 35.2587 34.5127 39.627 5.22859 0.340849 -7.95454 -1186 4 36.3572 33.4874 38.6664 0.260323 14.7009 0.217726 -1187 4 37.2087 35.8382 37.5664 -16.1128 3.65721 5.42823 -1188 4 35.4477 35.6456 35.7653 9.36321 -17.9472 26.5571 -1189 4 34.3056 35.0154 36.9225 -21.8403 -4.8414 12.2215 -1190 4 35.6878 33.9672 36.6241 -0.675121 9.51327 -11.2908 -1191 4 35.3533 37.7352 37.5449 14.646 -26.9923 30.0517 -1192 4 36.0883 37.365 39.2255 0.238586 8.99863 9.94523 -1193 4 34.398 36.7236 38.7331 27.4296 3.60145 2.66053 -1194 1 36.5178 33.9861 0.43319 -0.886806 18.5628 10.9627 -1195 2 36.4316 33.2481 1.68402 -23.714 -26.6299 -2.13495 -1196 2 35.1244 33.7124 2.42366 15.5385 -30.3313 2.36588 -1197 3 34.7644 34.9026 2.51705 2.20922 -14.5348 -10.7235 -1198 4 35.9714 34.8641 0.38304 3.21168 -9.87759 6.15105 -1199 4 36.3983 32.0948 1.44989 -1.82422 33.6343 5.26777 -1200 2 37.6595 33.5578 2.59019 11.8109 -15.526 -8.95992 -1201 2 37.7925 32.6548 3.8947 -1.46637 37.0951 -40.7395 -1202 2 39.0729 32.9162 4.76145 9.33062 17.9701 -6.69315 -1203 1 39.1272 34.3057 5.34055 -12.0513 -47.2871 -14.6565 -1204 2 40.0361 34.6964 6.22226 19.4309 2.99614 33.8109 -1205 1 41.0505 33.9844 6.76852 5.72064 -28.58 -41.8643 -1206 1 39.7581 35.8909 6.75898 -16.291 -41.0737 -43.8581 -1207 4 37.6558 34.6526 2.69615 5.74115 8.80853 20.4616 -1208 4 38.5677 33.342 1.97837 2.62182 1.38243 0.976295 -1209 4 37.7082 31.6119 3.52088 7.51898 -7.43262 10.1799 -1210 4 36.8684 32.8569 4.46033 -3.22235 -4.22142 15.6354 -1211 4 40.0987 32.7161 4.26669 -27.6432 -2.90908 0.926336 -1212 4 38.962 32.1623 5.56307 10.4764 0.325422 12.3641 -1213 4 38.2956 34.9173 5.26655 4.54825 -8.39051 -8.34855 -1214 4 41.5169 33.1039 6.38476 -28.6266 25.8655 1.14646 -1215 4 41.608 34.3491 7.51377 7.8916 19.9746 23.1278 -1216 4 38.9281 36.336 6.40181 -18.5651 19.0558 1.42199 -1217 4 40.2702 36.4189 7.40653 35.8571 19.9594 40.0309 -1218 1 34.4344 32.6714 2.9841 11.9274 27.4669 5.1488 -1219 2 33.2874 32.9292 3.81699 -8.08564 -7.68863 -5.88537 -1220 2 32.3224 31.7651 3.90854 -17.2979 -17.3182 38.1098 -1221 3 31.6331 31.611 4.98833 24.1293 6.49939 -41.9496 -1222 4 34.8176 31.7057 3.00707 -6.83555 3.8884 -0.368261 -1223 4 33.5991 33.291 4.83995 -4.39941 -8.915 -13.4113 -1224 4 32.6658 33.7351 3.38441 -0.220857 8.92322 -1.65762 -1225 1 32.2676 30.8833 2.86064 7.18924 -6.28537 -11.1453 -1226 2 31.5304 29.6622 2.84554 -44.3988 -8.55194 41.4736 -1227 2 32.0114 28.4719 1.98523 24.1065 42.5964 20.3644 -1228 3 31.2338 27.9142 1.1781 -2.45095 -15.5808 -11.9787 -1229 4 32.835 30.9065 1.99868 7.60542 11.1676 6.22148 -1230 4 31.4977 29.325 3.94534 -1.848 -5.68036 -21.1002 -1231 4 30.428 29.9278 2.63242 23.021 -11.1829 0.219584 -1232 3 33.2484 28.1785 2.03016 -12.1294 -5.65166 -6.61988 -1233 6 29.6841 33.0367 2.60309 -21.6771 -19.3453 -3.47113 -1234 4 28.7948 33.122 2.96731 -0.0142705 6.34055 1.55972 -1235 4 29.6278 32.12 2.27587 17.6678 13.2788 -5.74715 -1236 6 1.91248 24.7582 28.0699 4.20875 0.224039 17.8866 -1237 4 1.01839 24.445 28.2798 3.51323 0.855994 -2.65004 -1238 4 2.43926 24.5752 28.8738 -5.90795 -3.90565 -13.7536 -1239 6 8.97597 35.4266 7.06834 5.04 -9.06312 -1.25332 -1240 4 8.25108 36.0541 6.94232 -0.597114 -1.88223 0.564045 -1241 4 9.78632 35.9205 6.90416 2.6498 8.25727 -2.9232 -1242 6 37.9306 35.2271 23.5275 -29.4197 8.6633 8.88923 -1243 4 37.6331 35.3765 22.6307 -13.538 -1.59668 -6.74716 -1244 4 38.842 35.1051 23.4294 41.2281 -9.97035 -1.96517 -1245 6 11.37 34.6061 20.3231 29.8185 18.8627 -18.7977 -1246 4 10.4583 34.7066 20.5358 -23.2141 -5.0309 12.4901 -1247 4 11.7775 33.9686 20.9051 -0.738527 -14.291 8.66526 -1248 6 3.04799 13.1152 13.5136 35.0099 19.4917 13.0876 -1249 4 2.1896 12.8159 13.7818 -12.1985 -3.35561 6.33527 -1250 4 3.35102 13.7724 14.1976 -9.84998 -14.2313 -17.3692 -1251 6 9.17749 22.3786 24.885 -4.81993 3.49977 17.5169 -1252 4 8.99718 21.9861 24.0258 2.67933 0.293026 -6.97176 -1253 4 8.3097 22.5185 25.3032 2.93356 -2.2731 -6.67367 -1254 6 31.1417 36.1188 7.44168 3.96214 -4.62609 4.57576 -1255 4 30.9859 35.1633 7.26174 3.91063 19.8072 -8.10584 -1256 4 31.8759 36.4086 6.86762 -9.43736 -11.0335 0.220205 -1257 6 20.3122 0.171955 30.1364 24.228 8.43021 7.74329 -1258 4 20.1467 1.09565 29.8896 -9.06662 -5.17995 0.122132 -1259 4 21.2388 0.205679 30.4532 -11.6638 -2.99571 -4.85501 -1260 6 32.6752 3.01477 5.14905 7.73556 0.409651 25.0992 -1261 4 32.0607 2.27652 4.98052 6.16059 10.1356 9.58904 -1262 4 32.7887 3.0902 6.13894 -10.3787 -11.0045 -24.4474 -1263 6 26.2394 8.28697 11.5977 20.1187 4.68976 23.8355 -1264 4 26.2546 7.39802 11.997 -1.81228 7.23555 -2.12718 -1265 4 26.8422 8.82061 12.1901 -18.4274 -19.7459 -23.7973 -1266 6 1.08156 20.2558 0.892389 0.445896 -40.4816 -11.3523 -1267 4 0.921065 19.2784 0.845371 -9.22979 28.4068 22.5673 -1268 4 1.8129 20.2775 0.290341 19.5395 18.0975 -11.5753 -1269 6 29.152 22.9159 1.42964 -10.353 11.3862 1.77115 -1270 4 28.6638 23.7219 1.70393 12.045 -15.0113 -5.27942 -1271 4 29.6471 22.6066 2.20087 0.367353 7.17244 2.17898 -1272 6 34.1439 34.8173 6.47837 -14.6134 34.7664 -13.6599 -1273 4 34.8234 34.3556 6.01831 17.3611 -13.8412 -2.82442 -1274 4 33.8746 34.3136 7.2252 -0.385324 -14.0922 18.4225 -1275 6 25.1602 37.1811 26.5285 37.3138 -10.4299 -24.6025 -1276 4 24.6611 37.8475 26.9305 -29.1138 25.753 30.5337 -1277 4 25.9902 37.6718 26.3423 -2.02618 -10.7722 -5.27175 -1278 6 14.5359 22.233 15.6757 -38.1082 -52.4317 -17.2355 -1279 4 14.0373 21.3219 15.6008 31.4468 51.1923 15.0921 -1280 4 14.2115 22.7284 14.9124 6.42666 2.88962 4.6194 -1281 6 2.85765 5.85542 4.07926 -11.0889 31.9932 11.5474 -1282 4 3.43051 5.71014 4.8302 4.50985 -17.8875 11.7313 -1283 4 2.47546 6.74142 4.27679 -1.8522 -19.462 -7.62003 -1284 6 27.6173 26.7153 22.7048 3.02536 -24.7668 37.2 -1285 4 26.7794 26.2561 22.7471 -5.49099 -10.4557 3.23975 -1286 4 27.5338 27.2427 21.9498 -2.81898 29.5538 -40.3285 -1287 6 17.7815 0.60275 22.3967 -9.44347 22.192 16.8557 -1288 4 17.1106 0.664367 23.1174 8.05472 -4.70436 -13.4643 -1289 4 18.0991 1.53066 22.3547 -2.50437 -12.3009 -7.04453 -1290 6 8.08803 9.43976 10.5674 4.80966 -47.9744 28.0614 -1291 4 8.01535 10.2871 10.1695 -8.25869 32.7817 1.56345 -1292 4 8.12483 9.46261 11.5696 0.628604 12.1613 -30.4224 -1293 6 15.3459 8.71493 30.7579 -11.6347 7.91644 6.32427 -1294 4 15.6589 9.0755 29.9373 15.0271 -3.29406 -15.5675 -1295 4 14.5238 9.21191 30.8811 4.80809 -7.40019 11.405 -1296 6 11.0133 17.2839 37.5617 38.0352 -12.2544 -11.7999 -1297 4 10.7898 18.2056 37.405 -17.5453 -0.0751596 7.29682 -1298 4 10.2607 16.7791 37.8546 -17.0302 3.42722 4.74802 -1299 6 42.1004 25.1498 20.3879 -5.861 18.5914 -24.6259 -1300 4 41.6093 25.7579 19.7998 14.6917 -4.46771 2.10695 -1301 4 41.6207 25.2703 21.1911 -4.19275 -5.86855 25.2901 -1302 6 25.8665 4.70671 33.8486 1.7241 -2.25531 12.4518 -1303 4 25.7694 4.46132 32.9448 -0.891619 -14.6084 -22.569 -1304 4 25.7648 5.65611 33.7952 0.475958 14.7418 11.4125 -1305 6 28.7412 10.81 24.3536 52.8166 -39.1996 0.778281 -1306 4 29.1275 10.6396 25.241 -21.7381 14.0631 -10.6288 -1307 4 29.4032 10.2753 23.8346 -27.1554 16.6107 -4.2243 -1308 6 5.01189 41.8147 11.1021 -10.1881 -24.042 21.7575 -1309 4 5.95007 41.5814 10.9281 -9.39093 5.64723 11.7156 -1310 4 4.65803 41.218 11.8386 16.8172 15.7397 -32.6044 -1311 6 51.752 12.7769 30.1551 43.115 4.76279 10.9474 -1312 4 51.4305 13.1775 29.3474 0.253404 7.28674 -13.194 -1313 4 52.748 12.9494 30.1798 -32.3905 -5.4963 0.108494 -1314 6 7.60816 6.20909 6.53323 -10.2625 -22.9413 3.332 -1315 4 6.75131 6.36879 6.93991 1.04412 16.1391 1.16177 -1316 4 7.47061 5.28848 6.27373 8.51121 0.713964 -9.51027 -1317 6 14.6661 26.987 30.1548 0.873164 4.36141 0.355215 -1318 4 14.582 27.1099 31.1251 1.36022 -4.92112 -14.8153 -1319 4 15.2266 27.7026 29.8055 -8.21389 -0.931444 11.6021 -1320 6 15.3264 3.73283 21.1643 -10.33 -3.58504 -6.01241 -1321 4 14.8638 4.27764 21.8464 -0.83547 -19.2341 -16.6374 -1322 4 14.7237 3.15769 20.6119 12.9204 22.2517 21.9232 -1323 6 18.6273 30.44 6.46759 12.0392 -23.7352 17.6185 -1324 4 19.0475 29.6706 6.98693 -16.3462 35.3997 -15.3304 -1325 4 19.3457 31.0864 6.33287 -5.93154 -6.64461 4.30044 -1326 6 40.7697 1.30953 12.81 -7.42069 2.69181 -0.220133 -1327 4 39.8771 1.67487 12.9664 8.30469 -1.85755 -8.75546 -1328 4 41.0842 1.69163 11.9727 1.23155 -3.30642 0.910493 -1329 6 17.7383 20.7435 41.5913 -9.25323 7.68498 -13.188 -1330 4 16.7989 21.0745 41.5362 27.0903 -5.35562 -1.00027 -1331 4 18.2994 21.1605 40.9095 -9.45455 4.50919 10.4973 -1332 6 20.4558 2.13279 12.3403 -30.0447 18.1891 -47.0851 -1333 4 19.8108 1.39557 12.2573 15.3988 9.29294 19.6505 -1334 4 20.198 2.64755 11.5038 12.9177 -17.2886 33.121 -1335 6 9.85302 37.1833 18.074 6.71136 -14.9304 -23.7857 -1336 4 9.92221 37.5908 18.9423 10.0316 4.42551 4.50256 -1337 4 10.7455 37.1149 17.635 -18.8442 6.56171 18.5414 -1338 6 22.8282 7.40677 18.9114 -6.23678 0.804763 -35.7596 -1339 4 23.277 7.74075 18.0859 -11.7777 -2.90663 21.4919 -1340 4 21.8757 7.287 18.6972 16.9035 1.85128 0.334711 -1341 6 12.8573 6.85868 39.0594 6.78943 -21.4649 -19.4044 -1342 4 12.3495 7.63841 39.2092 -16.9303 20.8315 3.03628 -1343 4 13.4346 6.77393 39.8096 4.28484 1.06254 16.6435 -1344 6 10.1565 2.40612 23.2517 -6.6479 23.561 31.1588 -1345 4 10.4099 1.98923 22.4441 -4.01424 -6.38426 -29.0568 -1346 4 9.49005 3.10319 23.0571 9.63138 -11.2124 -3.87372 -1347 6 12.5542 20.2161 19.5705 -7.34833 3.07917 -34.9419 -1348 4 11.7057 19.8107 19.7825 -3.93433 -3.45282 3.31954 -1349 4 12.4683 20.3478 18.5882 13.2674 0.522362 30.6915 -1350 6 53.8557 6.35775 18.9347 50.5758 7.3162 -16.743 -1351 4 53.0168 6.07594 19.2456 -23.2698 -10.9568 16.0684 -1352 4 54.5479 6.04339 19.5529 -19.4302 5.44353 -5.27334 -1353 6 1.75058 4.00903 13.2441 23.5728 -28.6973 -20.2265 -1354 4 1.21884 4.54583 13.7916 -24.4496 15.7193 15.6535 -1355 4 1.39876 3.10072 13.3493 7.47096 11.1043 -1.96467 -1356 6 2.68902 16.4655 4.58797 17.5454 -16.7281 26.1549 -1357 4 3.46748 16.2798 5.17846 -23.6637 11.3752 -17.7986 -1358 4 3.0109 17.1109 3.97132 2.36318 9.59715 -15.9168 -1359 6 22.6274 7.40182 35.0529 -33.099 -8.93325 -69.8706 -1360 4 21.8922 7.07895 34.3703 46.348 20.1786 48.898 -1361 4 22.5995 6.76718 35.7474 -8.35572 -20.8537 22.0506 -1362 6 30.6396 27.885 19.9 19.0923 35.3411 -25.0547 -1363 4 31.1106 28.5954 19.3754 -18.5592 -24.8751 19.2783 -1364 4 29.9814 27.5098 19.295 5.17179 -8.35919 5.46264 -1365 6 18.3573 9.54392 6.2041 9.96047 7.12844 39.1223 -1366 4 18.327 9.09374 5.37857 3.10343 -12.6247 -24.8999 -1367 4 19.1177 9.18386 6.70986 -9.9052 0.872737 -11.1311 -1368 6 21.018 30.3894 30.8381 -12.2875 -2.46479 40.1773 -1369 4 21.7266 31.0151 30.932 9.98027 8.24448 -8.07198 -1370 4 20.7269 30.28 31.7939 -0.642204 -5.24287 -40.3987 -1371 6 28.323 4.36597 15.0837 1.12527 39.8195 10.6489 -1372 4 27.8986 3.55092 15.2676 -12.4099 -32.2848 2.02696 -1373 4 29.0009 4.19376 14.4446 14.1396 -7.65384 -8.86362 -1374 6 12.7814 0.64254 16.5262 -20.2521 41.8336 -1.49998 -1375 4 13.0387 1.47629 17.0069 -1.64601 -27.4009 -13.133 -1376 4 12.0897 0.933072 15.8712 20.715 -4.46996 16.4219 -1377 6 27.5603 35.1844 8.24072 -26.8161 -1.20469 12.7263 -1378 4 28.0791 35.3455 7.47089 6.94403 2.76433 -19.537 -1379 4 26.8275 34.582 7.96906 18.9853 12.4469 9.56437 -1380 6 24.0704 5.17451 40.9985 43.9791 -14.9803 45.716 -1381 4 24.6298 5.96615 41.2045 -19.6374 -8.83437 -20.0494 -1382 4 23.3625 5.28724 40.4007 -22.1054 20.8081 -27.5224 -1383 6 16.8467 24.9145 28.3061 -32.8066 71.0274 -23.4158 -1384 4 15.8676 25.1613 28.454 39.6061 -31.4713 1.92714 -1385 4 17.0718 25.6559 27.6632 3.37355 -28.1253 20.4487 -1386 6 20.8411 12.7971 17.0095 43.3655 -24.1139 -5.17775 -1387 4 20.9692 13.6698 17.4217 0.0861137 -1.96629 -7.53612 -1388 4 21.7712 12.4167 16.7645 -47.1299 18.5523 16.3808 -1389 6 35.7683 23.0344 30.9263 1.08866 -13.108 5.55839 -1390 4 34.803 23.1301 30.928 3.64223 -3.31893 2.04139 -1391 4 35.9803 22.5404 31.7512 0.26244 15.2618 -11.5602 -1392 6 36.3065 21.404 25.8788 21.1988 16.3215 -11.4752 -1393 4 35.3711 21.2912 25.8279 -29.04 -8.19979 -7.71966 -1394 4 36.6742 20.6179 26.2596 7.44281 -15.7003 9.85929 -1395 6 13.4865 6.74911 5.29345 -32.6693 78.3701 45.7352 -1396 4 13.9616 6.05619 4.98306 41.5093 -80.328 -47.9816 -1397 4 12.7805 7.00791 4.71674 -14.9335 -5.37764 -13.3979 -1398 6 20.8104 20.4092 13.7653 1.99296 11.0688 -14.7475 -1399 4 21.268 20.4545 14.5989 11.9976 -3.76106 7.6647 -1400 4 19.8959 20.3184 13.9984 -15.4264 -4.27358 -1.02469 -1401 6 20.3637 29.125 1.38742 -7.39452 3.20569 15.6829 -1402 4 20.6257 29.8678 1.97015 -13.6171 -7.9879 -3.97808 -1403 4 19.4728 28.7955 1.69287 22.5847 10.4694 -9.78123 -1404 6 50.8792 13.1212 37.2655 -4.22961 23.9091 37.9372 -1405 4 51.3893 12.5589 37.8771 -2.47029 4.54984 -9.0483 -1406 4 50.5869 13.8674 37.8656 5.03029 -21.5284 -25.2034 -1407 6 33.9282 34.1694 20.494 -12.758 16.9363 4.62304 -1408 4 33.9505 34.3661 19.5368 -1.52487 0.481952 13.5649 -1409 4 33.2327 34.7631 20.901 14.0918 -19.53 -17.3949 -1410 6 26.2111 28.0581 27.5584 -15.6012 -12.4051 -9.62147 -1411 4 26.6887 28.3319 28.3498 -5.67664 4.83839 -0.885474 -1412 4 25.2376 28.0657 27.7416 20.5709 -1.16679 -1.23567 -1413 6 7.682 21.3042 4.28531 -31.6563 9.11884 52.3302 -1414 4 8.36407 20.9023 3.81015 41.1991 -18.6864 -33.8238 -1415 4 7.19271 21.9105 3.74865 -6.01459 10.7978 -19.2095 -1416 6 22.0049 15.1615 5.91526 -5.59087 32.8095 7.59658 -1417 4 22.5291 15.4011 5.14076 -1.79158 -8.25489 -6.60562 -1418 4 21.8369 14.2416 6.04435 2.97447 -25.4321 -3.26552 -1419 6 21.7136 24.0096 3.8157 22.5859 -13.9702 -11.1371 -1420 4 22.6792 24.1846 3.95073 -20.2229 4.30251 2.28349 -1421 4 21.6957 23.2604 3.18041 -1.04284 4.75891 13.5064 -1422 6 11.5672 23.7812 12.5534 10.6653 17.5289 -0.525849 -1423 4 11.8567 24.7317 12.4283 -11.704 -31.033 2.93832 -1424 4 11.2483 23.6794 13.4494 -5.02459 5.94744 7.15157 -1425 6 32.3679 18.058 29.8144 -2.59991 12.5874 27.6023 -1426 4 33.2958 17.8537 29.9681 1.40206 -2.08885 -2.88861 -1427 4 32.1708 17.8352 28.9168 3.64727 -16.5589 -23.8097 -1428 6 9.27501 12.3901 30.3257 8.89695 -9.73537 -4.18026 -1429 4 8.97738 13.0169 30.9954 -4.04452 2.00113 -0.0309771 -1430 4 10.1278 12.0418 30.6776 -19.7256 9.24572 -11.0885 -1431 6 40.1671 25.9203 9.1352 -31.1658 -6.55029 4.71016 -1432 4 40.7952 25.2818 9.45931 8.36253 -10.0667 -0.250848 -1433 4 40.6474 26.7215 9.01492 17.3912 21.2934 -6.4579 -1434 6 43.1616 32.3487 37.3267 7.45809 -19.2286 11.3512 -1435 4 42.8399 32.8446 36.5586 -11.2032 -5.45956 10.184 -1436 4 42.4733 31.7245 37.6799 8.3011 17.0164 -20.2151 -1437 6 44.0911 6.28198 31.259 8.64406 -6.47735 -33.2401 -1438 4 43.4563 6.84482 31.6606 -21.1773 24.4303 10.8162 -1439 4 44.5952 5.92873 31.9644 15.9286 -14.2375 24.3689 -1440 6 10.2063 18.8787 19.6978 14.6089 -0.63771 -2.74842 -1441 4 10.128 18.3979 20.5267 6.04825 -4.13467 -1.20166 -1442 4 9.36891 19.3219 19.635 -15.0357 8.38504 -1.1225 -1443 6 7.0561 15.5922 15.0299 -16.4573 19.9198 -23.3889 -1444 4 7.18612 15.4783 14.0721 1.05096 2.95086 4.94392 -1445 4 7.41457 14.833 15.4354 13.8635 -34.6267 13.25 -1446 6 24.544 3.4899 27.8655 -14.5565 -8.97091 -7.81951 -1447 4 23.6823 3.28725 28.2588 1.61952 11.0081 14.175 -1448 4 24.3729 3.16547 26.9791 10.0044 -2.74415 -7.35546 -1449 6 54.4109 31.8087 9.71194 -6.99911 23.6955 33.3298 -1450 4 53.8413 31.5567 9.00593 -8.22136 -4.9258 -26.1741 -1451 4 54.0752 32.6964 9.97695 10.2913 -15.383 -7.59421 -1452 6 6.81072 17.0817 36.2069 -39.6649 -0.569341 -18.8672 -1453 4 5.9036 16.7161 36.0961 17.2423 3.35707 18.397 -1454 4 7.03883 17.1994 35.2786 19.8939 2.17194 6.76773 -1455 6 28.6373 7.46216 20.4204 -3.00228 3.72915 -26.9716 -1456 4 27.791 7.71165 20.8314 -1.23568 -3.59083 -7.19581 -1457 4 28.5788 7.67124 19.4449 -3.89686 1.20908 30.1283 -1458 6 17.0427 1.7136 8.36469 -7.39711 4.96373 -17.441 -1459 4 16.9511 0.79552 8.17539 8.34993 -30.6792 14.2707 -1460 4 16.7364 2.03503 7.50962 2.58977 23.9868 7.32556 -1461 6 19.1319 19.334 35.5748 25.2315 11.3156 3.71898 -1462 4 18.4163 18.7293 35.4559 -12.7574 -15.0058 -3.77114 -1463 4 19.9108 18.8059 35.8312 -7.49406 2.79856 2.97864 -1464 6 7.31044 31.3665 13.5876 -12.5896 -10.3186 -18.1643 -1465 4 6.86348 30.5057 13.838 5.41483 30.5465 -8.86898 -1466 4 6.71656 31.9291 13.023 7.05746 -22.9991 7.02109 -1467 6 16.6555 5.24573 12.8486 0.44122 -36.1931 20.2204 -1468 4 17.4189 5.79101 12.9112 23.6003 17.0932 2.01526 -1469 4 16.8511 4.45507 13.4194 -12.0332 11.5633 -21.5138 -1470 6 43.8917 12.7482 34.58 -33.2024 -13.6106 -1.45858 -1471 4 43.9807 13.5999 34.156 2.60816 15.5254 -0.13451 -1472 4 42.9242 12.5381 34.5161 22.3754 -3.96122 -2.5942 -1473 6 42.656 36.4522 28.5282 -7.17959 22.9727 1.13167 -1474 4 42.279 37.3416 28.6522 -7.55712 -15.8866 -0.526154 -1475 4 43.5285 36.675 28.2003 16.3904 -10.8581 0.329061 -1476 6 35.3704 15.0467 6.02622 35.7531 43.3754 17.6476 -1477 4 35.9258 15.8884 5.86958 -26.5611 -35.5954 0.991204 -1478 4 34.7923 14.9488 5.27074 -5.69332 -0.0870189 -10.0798 -1479 6 19.4034 5.85396 6.19026 -42.6676 -37.2433 -25.4755 -1480 4 18.4973 6.11578 6.46985 14.7962 -6.51198 7.73248 -1481 4 20.0178 6.47164 6.48735 29.6225 43.4574 23.1864 -1482 6 29.2636 38.16 6.98139 -51.0091 34.2659 0.167673 -1483 4 28.4794 38.0546 7.56687 16.6219 5.90534 -14.0005 -1484 4 29.8812 37.5458 7.29338 34.0617 -33.3732 10.6718 -1485 6 19.3639 26.1879 8.4772 -1.75021 -19.5484 18.4946 -1486 4 19.3765 25.7536 9.37133 0.505418 11.6152 -20.7618 -1487 4 20.132 25.8039 8.02679 -2.64689 1.58972 6.88257 -1488 6 4.91801 16.6546 6.12902 16.8332 -1.31437 8.04366 -1489 4 5.58152 17.3 5.84506 -6.45866 4.1219 -0.991793 -1490 4 5.39084 15.8022 6.09449 -7.75564 17.9483 -2.53018 -1491 6 6.07873 16.6931 28.0679 20.4204 4.35008 -35.2212 -1492 4 5.19925 16.4426 27.8453 -29.7482 -9.15572 9.47762 -1493 4 6.44387 16.7631 27.1426 -3.77999 2.92972 38.3228 -1494 6 21.7313 29.3584 22.0941 -19.989 26.599 40.0594 -1495 4 21.5191 30.3374 22.0902 3.30888 -28.6715 -0.0155919 -1496 4 21.2646 29.0087 22.9228 20.4195 8.84702 -28.341 -1497 6 24.487 0.545827 12.8459 24.5625 -19.0276 8.44191 -1498 4 24.0381 0.883409 12.0817 -9.22903 10.6064 -10.7293 -1499 4 24.0836 0.980384 13.5911 -6.14963 8.46579 8.44801 -1500 6 18.4109 28.2545 40.3162 -15.9129 36.5713 -32.2972 -1501 4 18.3366 27.7076 41.0573 0.952339 -31.6797 34.0712 -1502 4 19.1875 27.9677 39.8503 10.0284 -2.61836 -5.50219 -1503 6 10.3807 17.4604 21.8947 -1.20821 -16.3296 3.13877 -1504 4 9.80057 16.6779 21.8113 10.8468 3.86983 1.60142 -1505 4 10.0443 17.9356 22.6521 -9.33664 9.03137 6.2204 -1506 6 13.5404 13.3591 39.6327 12.5768 11.767 30.0264 -1507 4 13.9188 14.1992 39.2886 -9.97897 -11.5724 13.3172 -1508 4 13.5464 13.3749 40.6413 1.33606 5.90172 -38.0522 -1509 6 19.5508 26.0247 24.7387 -47.8665 -1.21537 -13.2845 -1510 4 19.6189 25.3328 24.097 -5.62542 -9.91951 -19.3965 -1511 4 20.3649 25.9852 25.1641 45.3739 3.88293 31.7071 -1512 6 8.93445 25.8823 20.0822 -10.4543 -29.9419 8.18251 -1513 4 8.35083 26.4773 20.5043 -33.2288 11.519 27.1484 -1514 4 9.504 26.5029 19.6962 43.6798 16.1155 -28.0388 -1515 6 13.4493 41.2138 30.5102 -4.84662 -36.1256 25.75 -1516 4 14.2597 41.094 31.0483 -5.58856 8.18726 -8.9115 -1517 4 12.8416 40.5025 30.8796 12.8197 27.661 -18.9522 -1518 6 21.1596 21.6794 11.1163 10.7366 20.8259 2.41134 -1519 4 20.9554 20.8709 10.6777 -10.2383 -24.5438 -10.817 -1520 4 21.2276 21.4421 12.046 -2.84377 -3.57945 5.82209 -1521 6 43.5643 10.3136 15.5616 17.5969 -21.741 5.94749 -1522 4 43.2379 9.48961 15.149 2.99942 14.1859 3.68588 -1523 4 42.9802 11.0242 15.3396 -21.8087 10.2132 -10.2755 -1524 6 23.5302 5.07333 12.3088 -23.5628 55.8128 -25.3063 -1525 4 23.4112 4.1923 12.0373 1.19089 -49.3933 -5.08619 -1526 4 23.0178 5.53904 11.5656 24.5614 -12.3881 30.382 -1527 6 9.28539 15.401 4.24759 1.63269 -5.62651 -9.8947 -1528 4 9.02922 16.1115 4.82738 -12.4128 14.4693 4.40189 -1529 4 9.90895 14.9318 4.78697 15.8319 -9.58935 3.85081 -1530 6 26.711 10.8797 17.566 5.43365 -10.3343 -26.0937 -1531 4 26.4818 11.0142 18.4585 -6.06422 3.32013 41.5711 -1532 4 26.8019 11.7518 17.1937 0.341074 3.88847 -5.26754 -1533 6 26.0592 23.5875 33.6794 25.1455 50.9154 21.2543 -1534 4 25.4682 24.0785 33.1024 -8.24785 -6.01089 -9.80751 -1535 4 26.6604 24.3213 34.0779 -26.6739 -38.162 -12.8336 -1536 6 7.57385 10.4949 28.9097 -14.7972 2.07126 0.456687 -1537 4 6.75277 10.5859 29.4011 -5.17598 -12.8295 -3.89358 -1538 4 8.06091 11.2035 29.3139 24.0536 5.38729 3.77373 -1539 6 16.4953 16.9073 24.6459 13.4535 22.6993 31.6086 -1540 4 15.9363 17.7011 24.6942 7.46422 -1.49957 -9.096 -1541 4 16.1467 16.4045 23.9375 -12.5815 -17.1437 -28.632 -1542 6 12.5505 12.7927 0.441559 26.7797 -18.4986 61.4448 -1543 4 12.8902 12.7839 1.42408 -16.6807 15.1369 -51.7767 -1544 4 12.972 11.9767 0.117581 -17.3776 3.59908 -10.4186 -1545 6 6.80454 2.46926 9.04378 10.3033 -16.1572 19.5551 -1546 4 7.05376 2.92505 9.85651 -1.04006 9.78535 -3.84035 -1547 4 7.36555 1.67892 9.06596 -6.07141 -1.3767 -9.09165 -1548 6 28.8788 11.8454 12.005 47.3119 33.3239 7.75537 -1549 4 28.2175 12.4307 11.6211 -4.89696 7.77957 0.00959457 -1550 4 29.7805 12.2922 11.8721 -37.0304 -14.6121 1.30522 -1551 6 44.6756 32.5924 29.7091 -46.8228 -4.47104 18.0754 -1552 4 43.7214 32.9254 29.5641 42.8383 -8.78111 -1.84094 -1553 4 44.558 31.8742 30.3802 4.31467 20.1075 -17.1439 -1554 6 28.6099 15.1189 32.288 -8.09168 -64.7739 -6.10589 -1555 4 29.0591 15.887 31.9855 13.2175 18.1439 -15.8441 -1556 4 29.0109 14.3064 31.825 -10.272 37.9041 18.9788 -1557 6 1.13952 22.1955 33.6303 -59.4889 25.247 28.7943 -1558 4 0.675447 22.8098 33.0333 5.4615 -9.68619 7.91413 -1559 4 1.8611 21.9185 33.1521 52.5767 -22.4691 -40.0321 -1560 6 17.4529 16.8222 9.92046 -20.0761 -24.0842 48.1247 -1561 4 17.9341 17.1517 9.19999 21.5054 13.464 -32.8219 -1562 4 17.9802 16.1035 10.3295 -2.40424 8.44812 -14.2536 -1563 6 18.74 29.8021 14.3918 16.1488 4.65404 69.9188 -1564 4 19.5966 29.6355 14.8679 -24.5899 1.22938 -11.6521 -1565 4 18.9027 29.6655 13.4911 13.4763 -5.12933 -46.2854 -1566 6 39.4106 6.51176 13.0171 8.18439 9.54271 -9.98348 -1567 4 39.7968 7.3217 12.6105 -7.82756 -18.4389 5.68309 -1568 4 39.8965 5.76959 12.6221 -1.11983 7.69721 6.02388 -1569 6 54.1122 38.2735 14.316 -26.3921 15.7841 23.5556 -1570 4 53.5092 38.7211 14.9446 14.1224 -15.8084 0.476194 -1571 4 53.7657 38.6747 13.5269 5.67525 0.359642 -25.5906 -1572 6 7.51656 32.0218 20.9281 34.7748 10.0158 34.1931 -1573 4 7.08362 31.9253 20.1193 -22.6959 2.07513 -43.8223 -1574 4 7.03544 31.4175 21.4603 -12.2713 -14.4046 24.4342 -1575 6 26.9722 15.5137 13.836 8.2831 -9.07996 -12.1546 -1576 4 27.2905 14.6773 14.2204 -10.3825 7.39938 7.42218 -1577 4 26.0228 15.629 13.9568 -6.27371 -3.74993 11.5294 -1578 6 18.3731 16.4369 32.1258 -5.47484 6.15837 -16.1574 -1579 4 18.1737 16.7054 31.2071 -0.945967 -8.38127 9.44724 -1580 4 19.0036 17.0959 32.4159 12.6478 4.85619 3.13766 -1581 6 52.4904 31.6749 23.2282 -45.8236 3.94874 65.5164 -1582 4 52.5054 32.2301 24.055 -6.11863 -14.7847 -21.5508 -1583 4 53.2278 31.9578 22.7624 44.676 11.2926 -39.5338 -1584 6 2.17063 9.69676 28.2025 -10.599 22.0242 17.0864 -1585 4 2.41083 10.574 27.888 12.6445 -0.15763 -12.1006 -1586 4 1.36653 9.91172 28.7063 1.66945 -10.1846 4.32482 -1587 6 32.9295 0.084333 22.579 -26.8721 -17.4052 -13.8633 -1588 4 33.2309 41.109 22.2818 0.690852 17.8844 8.89147 -1589 4 33.6446 0.598803 22.932 23.7791 -0.031599 0.0852179 -1590 6 20.7171 41.5453 38.643 51.9522 19.855 -62.1487 -1591 4 20.0643 41.0408 39.0691 -29.2365 -22.9372 13.5286 -1592 4 20.9788 41.0468 37.7869 -12.0924 18.2625 49.3819 -1593 6 43.2965 24.3242 12.1559 29.4143 27.7167 -28.3716 -1594 4 43.2964 25.2918 12.2975 -10.3211 -14.9579 7.88207 -1595 4 44.0244 24.2792 11.4826 -12.2932 -11.2644 22.4039 -1596 6 22.0333 36.2992 11.8143 -17.8744 11.1706 -5.23693 -1597 4 21.6038 36.9407 11.2131 12.0614 -9.84488 11.7859 -1598 4 22.8639 36.0559 11.3996 4.49067 -2.6397 -1.6843 -1599 6 50.7446 20.5307 30.3299 -19.4296 24.1009 0.394401 -1600 4 50.3769 20.0585 31.0978 -4.60399 -0.499453 -6.82258 -1601 4 50.1204 21.2977 30.1594 19.9431 -26.9935 4.34337 -1602 6 20.8379 3.84934 18.1872 -10.63 2.24574 17.9634 -1603 4 21.6372 4.15439 17.7675 6.81748 4.13844 -2.44268 -1604 4 20.7537 4.31685 19.0447 1.53322 -4.30004 -12.0579 -1605 6 4.001 20.6421 6.99361 -18.7611 -9.71733 3.72301 -1606 4 3.09723 20.6004 6.53941 30.5715 -8.65918 22.3858 -1607 4 4.00786 20.2035 7.89591 -15.2068 14.2544 -28.772 -1608 6 11.948 15.4413 41.4409 9.86263 -45.3449 -5.39948 -1609 4 11.9713 14.4541 41.6361 -2.32711 35.624 3.02695 -1610 4 12.4708 15.4889 40.6181 -5.28805 11.0492 6.42 -1611 6 3.00764 18.5435 38.9252 6.90717 -29.584 40.0663 -1612 4 3.56523 17.7255 38.8717 -9.75827 16.9893 -1.25399 -1613 4 2.92934 18.9138 38.0721 -1.66709 15.3109 -35.9518 -1614 6 8.5978 38.8858 11.3072 48.4025 32.5603 4.46589 -1615 4 9.44036 39.0024 10.7943 -20.5341 -1.07382 9.55064 -1616 4 8.19448 38.1327 10.9484 -22.3544 -46.6733 -17.9601 -1617 6 12.9691 33.9778 38.4933 34.8069 -13.3685 -21.4899 -1618 4 12.6573 33.2385 37.9471 -9.06758 1.22663 10.2849 -1619 4 13.9307 33.983 38.2659 -20.4066 10.3952 14.8996 -1620 6 4.69069 11.9902 6.04709 5.57568 0.955193 2.63183 -1621 4 3.83092 11.6207 5.79405 1.19943 -2.71585 -3.65246 -1622 4 5.36696 11.7708 5.36999 -19.9658 -4.94035 2.87891 -1623 6 10.8381 15.9154 25.2196 -36.4648 2.02786 -4.38258 -1624 4 11.7191 16.2167 25.3262 31.8449 11.9168 5.4517 -1625 4 10.3518 16.6682 24.8476 5.65772 -8.76316 -0.529027 -1626 6 20.7604 3.23767 6.55488 4.15603 28.9608 0.670607 -1627 4 20.2106 2.56517 6.18958 -7.79877 -24.0058 -5.45951 -1628 4 20.2434 4.04703 6.45055 -2.36445 1.41903 2.77062 -1629 6 47.6381 39.1588 31.2153 -11.506 28.7103 -40.9212 -1630 4 46.7125 39.0803 30.8864 16.1685 3.01672 12.9065 -1631 4 48.0161 39.883 30.6238 -10.851 -36.2784 24.6994 -1632 6 8.33868 27.7571 27.6932 -33.938 3.65348 13.4266 -1633 4 7.90796 26.9962 28.1436 6.90464 18.5991 -0.450451 -1634 4 9.05762 27.3551 27.2376 19.8804 -10.068 -12.1598 -1635 6 33.245 40.3099 33.4253 18.3517 22.2199 -28.9554 -1636 4 32.5937 41.0038 33.2194 0.94932 -12.4457 9.89811 -1637 4 33.9479 40.492 32.7526 -7.59275 -9.33057 17.0692 -1638 6 24.5058 34.6327 27.2588 -1.70215 14.4876 -27.3243 -1639 4 24.8356 35.5409 27.0166 -5.53884 -24.0927 13.0812 -1640 4 24.1351 34.315 26.3934 7.47117 3.95694 29.9195 -1641 6 13.3256 36.76 35.7403 23.371 22.3884 -21.319 -1642 4 14.292 36.6204 35.8687 -19.0607 -2.42845 14.454 -1643 4 12.8134 36.0651 36.1242 -8.79549 -23.1532 9.33092 -1644 6 34.0568 20.1616 33.2139 18.2744 1.49148 -3.34215 -1645 4 34.901 20.3965 32.7524 -27.9907 10.0382 9.43414 -1646 4 33.5726 20.9405 33.5892 13.555 -8.0917 -8.63642 -1647 6 22.8329 33.5616 31.6214 -12.6844 15.5573 -21.5595 -1648 4 23.5755 34.1858 31.5969 1.53708 -3.14405 -0.637663 -1649 4 23.0292 32.8658 32.2325 13.4469 -12.4025 17.113 -1650 6 23.7434 2.42786 19.8498 9.49596 22.5629 12.9133 -1651 4 24.532 1.90722 19.7117 15.1933 -8.07802 -2.32773 -1652 4 23.0629 1.99408 19.3682 -23.4605 -15.8437 -14.4607 -1653 6 10.59 1.63974 20.5169 -0.95575 -6.83071 6.14558 -1654 4 9.98705 1.03236 20.0473 7.71399 2.84727 3.14747 -1655 4 10.6246 2.47233 20.0276 -8.35822 1.7372 -3.87231 -1656 6 6.50082 24.8628 7.81243 5.63459 3.09475 -4.38693 -1657 4 7.40706 24.9537 7.44087 -14.825 -10.0154 1.3351 -1658 4 6.01351 24.1359 7.38457 10.3118 5.93376 -6.27471 -1659 6 54.7907 32.5298 25.4601 2.42441 14.1538 -12.299 -1660 4 54.0693 33.194 25.3949 12.697 -15.3913 -0.923548 -1661 4 0.387469 32.6052 24.6546 -22.4501 -0.197402 25.3904 -1662 6 6.24565 20.1804 28.9699 -20.0835 16.2671 13.5362 -1663 4 5.37616 20.2206 28.5173 17.3942 -4.89439 1.50138 -1664 4 6.85708 19.7029 28.4106 5.94408 -11.9876 -6.03836 -1665 6 50.061 21.6087 11.3404 -11.515 44.0552 -42.0488 -1666 4 50.9725 21.751 11.0493 2.56545 -3.3262 -1.97817 -1667 4 50.0662 20.9568 11.9903 8.13397 -42.2403 36.0281 -1668 6 43.4741 33.5215 19.648 39.1267 -7.16957 -40.9914 -1669 4 43.8052 33.5504 20.5247 -1.27694 2.64583 28.8889 -1670 4 42.5461 33.5822 19.6063 -36.855 5.29583 12.3512 -1671 6 30.8225 7.19458 41.0729 -33.0718 18.8928 10.1641 -1672 4 30.0173 7.64992 40.6345 32.3343 -18.9847 22.962 -1673 4 30.7853 7.47469 0.131591 -1.52838 -8.42988 -38.7943 -1674 6 12.1264 25.8478 11.0965 -41.5825 -1.76886 -24.0951 -1675 4 11.2804 25.9828 10.5746 22.2453 -8.09118 27.7312 -1676 4 12.6111 26.6214 10.8799 25.9351 22.819 -1.42381 -1677 6 47.8207 5.82713 17.7363 28.7614 -16.7343 -8.46055 -1678 4 48.0335 5.15295 17.0353 -2.74159 24.5551 13.4979 -1679 4 48.6986 6.12754 18.0988 -19.3132 -4.26463 -8.98138 -1680 6 35.1697 12.9074 16.5814 -26.6969 23.1645 14.7724 -1681 4 35.331 12.9801 17.5341 9.94288 -5.95548 -5.31324 -1682 4 34.5116 13.6489 16.4838 18.7069 -22.8028 -11.189 -1683 6 10.4746 10.6344 33.9856 -30.1195 -20.4446 -6.31426 -1684 4 10.7944 11.3866 34.5009 -4.55531 -6.56386 0.452866 -1685 4 9.59186 10.377 34.349 25.6427 10.4215 -3.60637 -1686 6 9.86976 7.46809 9.66723 13.2706 -15.2427 -11.6817 -1687 4 9.07254 8.00079 9.6953 0.322066 10.4083 -1.78771 -1688 4 10.1027 7.29929 8.72005 -15.6005 8.2826 19.6359 -1689 6 11.1498 9.5629 29.1446 -4.60031 -6.3451 3.75047 -1690 4 10.6862 9.26798 29.9509 5.10767 2.07156 -10.4371 -1691 4 11.3249 8.76682 28.6116 2.75639 0.845127 6.4689 -1692 6 46.3982 12.7571 37.8973 13.0728 8.65129 -14.0384 -1693 4 46.6651 13.0033 36.9771 -6.5436 -6.98702 17.4091 -1694 4 46.8422 13.384 38.4935 -4.33131 -5.25976 0.421567 -1695 6 4.7745 19.0249 15.9997 -22.3762 2.96494 22.3523 -1696 4 4.16029 19.0173 16.7572 4.82074 7.85299 -8.34635 -1697 4 5.51792 18.5695 16.4006 17.242 -3.98645 -13.636 -1698 6 50.2756 39.8187 19.3535 -48.7732 -19.7782 -8.19609 -1699 4 50.1357 39.0812 19.9713 14.3147 6.83039 4.1366 -1700 4 49.4547 39.7468 18.7938 35.5854 8.27631 5.22634 -1701 6 3.57022 23.2982 26.3116 -7.21736 12.7853 -4.33091 -1702 4 3.04677 23.327 25.4841 2.15403 -9.28995 15.8001 -1703 4 3.1589 23.9918 26.8774 3.27351 -16.4313 -7.87876 -1704 6 43.3323 18.2357 20.5099 -9.76971 -1.121 -6.56922 -1705 4 42.7632 18.9863 20.7177 2.34101 2.93749 0.115163 -1706 4 43.9096 18.122 21.2711 1.48233 -4.92166 7.17918 -1707 6 14.4939 41.5272 19.7194 7.33174 -3.95938 -8.98841 -1708 4 13.9791 41.768 20.4704 -25.804 7.49044 14.4407 -1709 4 15.35 41.4773 20.1189 24.9681 -5.23262 -6.74673 -1710 6 29.2751 29.8624 26.915 55.5011 14.3278 -64.7852 -1711 4 29.462 29.6739 25.9095 -28.0317 9.76644 54.5148 -1712 4 30.1137 30.3565 27.1616 -29.5885 -20.0698 8.89328 -1713 6 6.32585 26.1455 11.5441 3.18215 15.5722 27.8672 -1714 4 6.22913 25.7559 12.4173 -5.87839 -9.43723 6.04013 -1715 4 6.88652 26.9071 11.7431 3.72153 0.148286 -16.8953 -1716 6 27.6581 9.23325 15.2376 24.6795 20.4415 1.81178 -1717 4 28.3906 9.86787 14.9946 -20.7277 -22.2866 6.02651 -1718 4 27.7257 8.49599 14.6233 3.42822 -3.8556 -2.27597 -1719 6 29.7826 38.0629 17.0951 -21.7625 -1.10982 -31.3954 -1720 4 29.5447 37.2807 16.5438 11.5646 7.7876 16.1146 -1721 4 29.1666 38.7512 16.7768 9.10566 -6.75007 12.2127 -1722 6 52.2237 28.7307 4.26632 40.7154 12.5569 -19.536 -1723 4 53.094 28.6942 3.75761 -25.982 6.02481 23.1744 -1724 4 51.8384 27.8718 4.17524 -3.40498 -27.0863 -4.04919 -1725 6 17.1651 16.6761 6.10093 10.0081 29.999 -15.4838 -1726 4 17.0645 17.5224 6.60658 -3.46995 -23.4179 -4.25622 -1727 4 16.9429 15.9406 6.65512 -3.52922 -13.7209 19.1007 -1728 6 36.6584 7.55275 33.426 1.51046 -27.4434 34.6673 -1729 4 36.0562 7.00422 33.9909 9.38132 12.247 -13.9906 -1730 4 36.0891 7.78594 32.7139 -15.8398 12.8789 -25.2624 -1731 6 26.1693 3.13272 9.58463 26.4836 36.1065 -53.3475 -1732 4 26.5189 3.61335 10.3026 12.8321 10.8542 33.1136 -1733 4 25.6805 2.43597 9.90138 -37.6231 -51.1462 30.1839 -1734 6 1.19232 17.1076 33.1734 0.722887 26.1228 -9.87087 -1735 4 1.0219 17.7977 32.4875 3.44775 -13.3597 11.6369 -1736 4 0.89275 17.4757 34.0242 -0.842403 -4.58413 -3.86686 -1737 6 29.175 10.1805 5.37687 2.48705 -7.47299 -1.58449 -1738 4 28.5307 10.3443 6.0806 2.54341 -1.49901 -0.102048 -1739 4 29.6529 9.35261 5.56356 -13.9845 3.47491 -0.693848 -1740 6 9.21964 21.135 0.193729 30.6013 -8.57211 -16.2038 -1741 4 9.93935 20.7152 41.5745 -5.21063 7.9265 20.924 -1742 4 8.4582 20.7874 41.6647 -18.4316 -1.36421 1.54976 -1743 6 7.41915 26.897 34.8578 6.273 24.0322 40.4596 -1744 4 7.07209 27.1094 35.7714 11.2799 -9.18849 -34.7736 -1745 4 6.87885 26.1925 34.5434 -18.5272 -22.724 -11.5995 -1746 6 18.6237 10.1563 3.02822 -55.9716 37.9013 1.68891 -1747 4 17.9823 9.44023 2.87563 14.9297 4.34306 1.98909 -1748 4 18.009 10.9755 3.18254 40.8652 -32.8317 -2.61569 -1749 6 13.1455 21.2337 25.2154 -14.3081 5.93545 -14.9534 -1750 4 12.8153 21.6822 24.4216 9.6722 -4.26313 4.93127 -1751 4 12.7862 20.3541 25.1726 -3.49479 -14.4912 -0.313259 -1752 6 4.91031 24.4198 40.532 -13.7809 -26.5024 -53.169 -1753 4 5.65778 24.4539 41.0894 26.3299 12.2697 26.6549 -1754 4 5.26856 23.9753 39.7091 -18.4358 16.5303 24.5031 -1755 6 54.7198 6.2862 9.93073 18.558 2.67796 -18.7732 -1756 4 54.1336 6.00192 10.611 -15.308 -5.80798 23.6242 -1757 4 0.005563 7.17106 10.1764 0.43073 7.36928 5.10877 -1758 6 51.7604 16.6436 19.3877 -20.3234 -7.55047 -14.8495 -1759 4 51.6779 16.1639 18.5383 1.1676 14.9854 4.84802 -1760 4 52.2077 17.4816 19.2574 16.3674 3.30585 -9.00164 -1761 6 38.6218 2.96001 13.0988 15.7387 3.67705 55.5859 -1762 4 38.6299 3.43096 13.9849 -4.06073 -12.9308 -23.724 -1763 4 38.2169 3.56793 12.5083 -12.8186 19.7945 -24.9943 -1764 6 19.4471 35.7007 9.61167 2.35324 -8.95281 6.35471 -1765 4 18.8335 36.2871 9.19379 -17.9936 2.63552 -14.7984 -1766 4 18.9495 35.3837 10.3842 8.56204 6.47345 -9.11173 -1767 6 46.9457 37.6212 25.7021 -15.6754 4.57489 10.5165 -1768 4 47.0239 38.0262 24.8354 11.6036 -0.197794 -10.4287 -1769 4 47.7281 37.1166 25.9279 8.14222 -0.129186 -6.11913 -1770 6 20.0249 17.2708 14.7582 9.34392 -2.11639 -6.02108 -1771 4 19.1723 17.4786 15.1706 12.7461 -0.873648 3.80655 -1772 4 20.7009 17.0069 15.4035 -13.3418 2.74043 0.572405 -1773 6 24.7358 29.2923 3.78206 18.5642 -33.4808 -47.1325 -1774 4 24.7422 28.3915 3.3709 -13.1038 11.8323 28.3161 -1775 4 25.3506 29.6775 3.14782 -2.77927 21.1078 10.4189 -1776 6 3.43141 8.92567 6.82668 25.8011 -1.75535 29.9445 -1777 4 3.08486 8.82716 7.75964 16.0017 4.22665 -30.6726 -1778 4 4.42441 9.10783 6.89545 -42.5611 -5.30748 1.54274 -1779 6 17.4891 30.59 19.7026 37.1524 -11.5388 -6.241 -1780 4 18.4343 30.3591 19.4199 -38.2372 10.1448 10.4771 -1781 4 16.9657 29.7875 19.5831 -4.14236 3.18225 -9.29444 -1782 6 13.2748 16.1833 39.0603 8.39615 -10.6604 2.01333 -1783 4 13.778 16.9491 39.3364 8.93523 3.59341 7.63718 -1784 4 12.5498 16.5465 38.5646 -17.693 7.52452 -10.3405 -1785 6 23.8419 27.9652 11.5971 -29.0622 15.8949 5.8355 -1786 4 23.0433 27.5239 11.9581 15.8216 -1.64981 -8.50246 -1787 4 23.6687 28.8945 11.8451 9.38175 -9.8305 -3.59643 -1788 6 14.4582 24.411 21.2251 -13.2323 27.0215 19.0701 -1789 4 13.9163 25.2229 21.3861 13.2503 -9.35589 -12.2275 -1790 4 14.348 23.9323 22.0593 -1.27999 -3.95586 -5.82862 -1791 6 46.6209 15.1404 22.2877 -21.0909 8.30909 34.5316 -1792 4 45.8336 14.7024 21.9608 7.3328 -3.88381 -14.3297 -1793 4 47.2246 15.4169 21.6106 10.5055 -5.27886 -22.0515 -1794 6 19.1453 29.7169 11.8746 -27.0123 -18.8736 -35.9167 -1795 4 18.7667 30.5363 11.5796 10.8323 29.6783 4.39578 -1796 4 18.5214 29.1838 11.3275 23.3568 -13.7991 20.8336 -1797 6 36.9132 18.8016 27.615 -17.0652 -23.8487 30.8874 -1798 4 36.4034 18.4868 26.8464 6.26881 1.65463 6.80847 -1799 4 36.6041 18.1666 28.3506 10.215 31.7365 -33.4968 -1800 6 35.8839 17.5137 25.5036 -5.81764 30.7264 -16.7466 -1801 4 36.5665 17.9094 24.9 -10.7703 -22.5287 9.19997 -1802 4 35.9135 16.5474 25.44 8.68204 5.15754 -2.43364 -1803 6 8.04468 41.8981 31.5366 26.4021 9.77217 -3.38911 -1804 4 8.66886 41.284 31.9946 -24.4733 15.0027 -13.0466 -1805 4 8.60227 0.704634 31.1522 -11.4596 -14.2431 6.13083 -1806 6 31.7024 34.8356 17.9299 26.5575 -27.0845 -4.88708 -1807 4 32.6196 34.4986 17.7931 -22.3662 0.836155 -3.84042 -1808 4 31.9071 35.6664 18.3392 -5.09232 26.8034 6.09861 -1809 6 22.0993 41.0535 5.13739 10.0927 40.3608 -89.4928 -1810 4 22.1435 40.6782 5.94278 2.96748 -46.7441 88.004 -1811 4 22.8097 40.6452 4.60918 -8.49191 2.25551 6.5005 -1812 6 11.6188 5.17183 29.5438 -37.4391 -17.3681 45.4318 -1813 4 12.0782 4.3477 29.7115 12.4576 1.56532 -11.0695 -1814 4 10.8376 5.06958 30.1835 21.3256 14.0691 -33.8944 -1815 6 13.0142 9.45267 21.0738 -17.3871 -39.5803 -33.4019 -1816 4 13.648 9.91302 21.5572 37.1542 33.3127 26.6408 -1817 4 13.4951 8.71823 20.6397 -14.9934 11.5246 2.17133 -1818 6 12.4259 4.16416 0.171584 25.5917 58.0572 -18.9009 -1819 4 12.7038 3.75631 0.988868 -0.121161 -3.62646 8.37405 -1820 4 12.9914 5.02921 0.073462 -27.1162 -49.1387 2.0493 -1821 6 45.1548 14.6294 28.1056 43.5869 -15.7342 -2.79686 -1822 4 45.3799 14.9442 27.2254 -14.4652 2.82802 -6.08545 -1823 4 46.001 14.1543 28.294 -26.1128 6.03561 5.66217 -1824 6 52.5819 19.2522 0.880939 -13.6546 -24.4625 3.21793 -1825 4 52.4967 19.3157 41.8353 6.16951 -6.72877 -2.3034 -1826 4 52.7342 20.1258 1.1855 8.55196 28.2584 6.16427 -1827 6 0.17636 18.5769 30.5692 -13.5341 -21.3209 11.3545 -1828 4 0.97347 18.6538 30.0344 3.16555 8.74201 -0.550561 -1829 4 54.7381 19.4288 30.6755 1.51483 11.9419 -1.05075 -1830 6 17.6474 28.1849 1.96582 -3.95698 7.79984 2.09024 -1831 4 17.0036 28.8884 1.72628 7.01161 -11.1903 7.18073 -1832 4 17.5665 28.0879 2.93205 1.48476 5.36119 -8.9874 -1833 6 22.5179 30.1562 5.01973 -0.557011 13.5756 -11.2394 -1834 4 23.053 30.1464 4.21842 7.71181 1.56353 5.86697 -1835 4 22.1417 29.2826 4.9966 -11.5089 -8.75783 6.0437 -1836 6 11.3992 8.80614 17.6425 18.8049 17.2909 -5.92301 -1837 4 12.0044 8.1818 18.0403 -8.94801 -14.7479 17.6102 -1838 4 12.0653 9.44286 17.3244 -18.8797 1.15675 -4.46111 -1839 6 32.2825 3.5901 26.8335 38.6865 42.7422 0.354813 -1840 4 31.9744 3.38447 25.9652 -16.937 -9.17442 -22.5821 -1841 4 32.8531 4.41036 26.697 -18.7333 -32.0278 -1.10411 -1842 6 26.8283 37.1448 15.664 9.9544 44.9512 -6.81835 -1843 4 26.832 37.6522 16.5019 -4.80771 -22.2764 -7.00776 -1844 4 26.708 36.2069 15.7377 -4.77442 -21.1488 11.5765 -1845 6 22.9466 3.40402 22.281 26.551 -3.46013 -1.27592 -1846 4 23.3626 3.00539 21.4748 -15.0613 6.75 14.6032 -1847 4 23.702 3.67884 22.8406 -14.5661 -4.86975 -12.1571 -1848 6 14.6187 28.2219 5.2011 12.2375 -1.31522 5.54773 -1849 4 14.146 28.1316 4.37141 -5.71124 1.87741 -8.30492 -1850 4 14.2863 29.0052 5.66137 -0.824291 -0.470469 -2.06805 -1851 6 20.2555 37.1856 16.5486 -24.9193 16.4856 21.7008 -1852 4 21.0596 37.4718 16.144 26.6499 6.5165 -11.4453 -1853 4 20.1477 37.8155 17.2956 -4.48599 -12.7862 -6.90992 -1854 6 17.9469 28.5629 23.8891 26.0841 -15.2841 -12.8531 -1855 4 18.7956 28.2639 23.4837 -20.5944 5.95667 14.8805 -1856 4 17.3322 27.8283 23.7208 -3.07308 9.52654 -1.59768 -1857 6 33.6454 24.2344 25.2281 6.08515 -19.3492 9.67379 -1858 4 33.7229 23.2583 25.1621 -7.7165 13.5894 -11.682 -1859 4 33.9838 24.3464 26.1231 0.527101 9.69022 -3.14208 -1860 6 9.99248 17.6305 2.22889 -2.94775 -31.1618 -12.577 -1861 4 10.7668 17.5307 1.6348 -7.17319 1.58445 12.7603 -1862 4 9.8062 16.7546 2.64219 6.61617 15.6433 -4.64734 -1863 6 24.3378 36.7975 8.92134 10.0949 -17.5556 18.6285 -1864 4 24.0798 37.5812 8.46711 -7.4438 24.0622 -5.98172 -1865 4 24.7733 37.0584 9.7453 -6.84359 -4.10885 -5.58351 -1866 6 14.3929 4.30304 27.7402 56.7365 -3.53996 19.7179 -1867 4 15.3546 4.44499 27.4586 -37.3153 -7.57895 7.00929 -1868 4 13.8272 4.37832 26.9899 -16.116 5.01688 -19.8092 -1869 6 13.2096 25.4586 35.3298 -3.87145 -6.51473 -10.8119 -1870 4 13.1476 25.2267 36.278 -1.83966 -3.78777 -13.8323 -1871 4 12.5545 24.9939 34.7684 5.09589 5.85633 19.2997 -1872 6 43.7315 33.1816 24.4051 17.2004 -9.02075 24.8986 -1873 4 44.3591 33.0681 25.1678 -20.1541 -6.26738 -17.3644 -1874 4 44.1096 33.9146 23.9227 -1.6352 8.32092 -8.69406 -1875 6 6.97009 30.4077 7.13769 23.121 1.43384 34.0809 -1876 4 6.71282 29.9591 7.9596 7.06976 3.62274 -2.26904 -1877 4 6.20421 30.2819 6.61977 -27.9511 -2.76807 -27.2062 -1878 6 44.437 39.4145 21.7835 -9.43682 11.6365 -18.5611 -1879 4 43.878 39.1032 21.0489 1.92512 -11.9494 17.5009 -1880 4 44.878 40.1639 21.3648 8.44417 -6.89071 6.17346 -1881 6 1.1648 16.4475 24.9778 -2.61131 5.39938 13.1681 -1882 4 1.07525 17.0286 24.1819 -7.88043 -13.0173 22.3573 -1883 4 0.434843 16.5677 25.6378 18.4556 1.9359 -28.7216 -1884 6 8.16988 33.8361 10.6637 16.6829 23.9256 47.7562 -1885 4 8.49559 33.5478 9.83195 -4.50358 -22.2449 -29.7436 -1886 4 7.35799 33.4028 10.9227 -18.4601 -13.1254 -8.86092 -1887 6 45.3716 15.8699 40.491 -6.36942 -3.03704 -2.15917 -1888 4 44.5133 15.7719 40.0601 4.63234 -6.98635 -0.416374 -1889 4 45.243 16.6248 41.0649 5.7116 1.92459 5.42472 -1890 6 38.7776 4.29245 15.9056 11.0795 0.30753 4.41463 -1891 4 39.6766 4.00679 16.0952 1.69097 -2.92337 -3.33067 -1892 4 38.5504 4.73291 16.7401 -7.14778 -2.92142 -9.36231 -1893 6 21.0846 9.20759 23.9691 5.60032 -0.18462 4.18544 -1894 4 20.9445 8.65571 23.1711 -3.69603 16.8592 7.46004 -1895 4 20.5672 10.0363 23.9442 1.93643 -14.5945 -11.3561 -1896 6 6.46938 36.1391 20.0069 4.0004 4.10087 4.13062 -1897 4 5.99357 35.3124 19.8297 -2.3473 7.0562 -2.30419 -1898 4 7.3052 35.893 20.4098 -0.600933 -5.92452 -3.30983 -1899 6 17.7588 23.4635 11.2444 16.528 -28.2646 53.7307 -1900 4 16.9432 23.8548 11.0264 -32.805 26.4079 -23.7501 -1901 4 17.621 23.3206 12.2167 9.32529 -0.814156 -28.2078 -1902 6 2.23938 39.2705 23.5372 32.4488 -19.3396 -21.3039 -1903 4 2.96143 39.1072 24.212 -19.8533 -4.03587 -26.9428 -1904 4 2.57592 39.0525 22.6024 -11.4643 11.6849 46.2914 -1905 6 21.7189 10.3135 3.08585 -2.90529 19.7604 61.578 -1906 4 21.843 10.1221 2.19424 -0.974385 -17.6276 -55.1642 -1907 4 20.7734 10.4085 3.28686 2.80557 -4.86174 -11.6796 -1908 6 13.3371 37.6485 26.8148 34.7445 -2.08205 -3.58175 -1909 4 12.7942 37.01 27.2655 -5.666 -15.7112 8.11946 -1910 4 14.1995 37.1812 26.5945 -31.1056 12.6209 6.4215 -1911 6 45.679 9.86525 8.82671 -1.22844 -5.97168 -0.0165319 -1912 4 45.3204 9.57969 7.98479 1.29945 7.51218 -9.52666 -1913 4 45.2548 9.27624 9.44517 -6.37871 -3.09075 9.62419 -1914 6 39.8117 32.343 29.5858 -3.04799 14.0722 -9.88422 -1915 4 39.6223 31.4471 29.2796 3.58631 -7.81261 7.71305 -1916 4 40.3439 32.3214 30.3816 0.770365 -10.1242 2.16071 -1917 6 39.1301 32.1592 8.96473 45.9624 -7.76569 -23.2306 -1918 4 39.6852 32.0596 8.1252 -31.4186 4.60772 35.1501 -1919 4 38.2007 32.2042 8.75798 -9.66602 0.778467 -8.76952 -1920 6 29.7501 11.3103 40.3404 42.6438 -12.6008 -10.1865 -1921 4 29.0692 10.6634 40.5326 -1.99158 -8.72077 -0.363163 -1922 4 30.6164 10.7842 40.3158 -34.6338 15.486 -0.0451708 -1923 6 24.8345 19.8801 29.8412 -7.59088 37.7695 16.0848 -1924 4 24.9026 19.0378 30.268 -1.65451 -21.4471 9.48031 -1925 4 24.5694 20.5293 30.547 8.64688 -23.6335 -15.2845 -1926 6 50.0799 29.4689 2.86832 11.3398 7.37373 -14.0975 -1927 4 50.7937 29.3382 3.51213 -5.95266 6.62042 -8.33887 -1928 4 50.5172 29.4209 1.98721 -16.9062 -3.16045 21.5768 -1929 6 26.3158 13.2487 37.9516 44.6834 6.62304 1.7852 -1930 4 27.2667 13.2121 37.7291 -19.4356 -10.4808 -19.3263 -1931 4 26.4654 13.336 38.8817 -25.2145 10.5198 25.1195 -1932 6 24.3285 13.817 16.1492 -2.87417 -29.0242 -9.8062 -1933 4 24.8278 14.0306 16.9324 2.95884 13.8503 11.1204 -1934 4 24.1796 14.5912 15.6032 1.91347 13.6823 2.96602 -1935 6 21.9624 25.0824 8.00452 15.4008 12.078 14.6814 -1936 4 22.598 25.7039 7.58094 -6.50256 -15.9793 3.04336 -1937 4 22.4506 24.6482 8.74092 -7.92214 9.81208 -17.5113 -1938 6 50.1646 25.295 29.0323 7.20414 -13.325 -13.2678 -1939 4 50.9752 25.188 28.522 -3.46618 -9.57224 -11.582 -1940 4 50.4808 25.9292 29.6536 -4.58067 20.151 23.6328 -1941 6 23.186 6.81871 7.63171 8.52809 43.4321 -4.70249 -1942 4 24.005 7.36604 7.81791 -26.2659 -19.6382 -4.15731 -1943 4 22.4749 7.49932 7.50679 12.9101 -23.886 0.0924589 -1944 6 6.93738 5.85096 20.8328 -1.25739 23.0019 -5.42089 -1945 4 7.49016 6.65136 20.6793 -8.05782 -22.0664 2.33926 -1946 4 6.43567 5.73489 20.0135 6.68134 -11.6114 -0.0369962 -1947 6 25.4027 39.7503 23.9523 -6.31967 32.2782 -31.5462 -1948 4 25.6215 38.8259 24.0292 3.86532 -10.8289 -5.32001 -1949 4 25.5293 40.0494 22.9984 1.78505 -20.5244 33.6821 -1950 6 10.8465 30.682 2.12076 -14.9417 -4.95607 29.3443 -1951 4 9.91334 30.8811 2.27771 3.65307 -4.25506 9.47201 -1952 4 11.0492 31.2188 1.38489 10.4343 12.2811 -36.8692 -1953 6 23.0846 40.5263 40.0577 -14.1833 12.856 -13.2149 -1954 4 23.7732 40.7716 39.4116 -4.4893 -4.99974 3.24897 -1955 4 22.2685 41.0049 39.7737 14.5189 -12.3092 -2.05606 -1956 6 29.2062 28.3669 37.5673 -46.9973 46.4688 -26.4511 -1957 4 28.2092 28.447 37.3765 47.4284 -5.55714 9.99444 -1958 4 29.3363 27.5265 37.9547 9.31284 -31.0764 15.334 -1959 6 1.86163 12.1711 18.0765 -5.91003 5.49035 -5.71632 -1960 4 2.55659 11.9166 18.6527 25.6221 -14.4574 8.12849 -1961 4 1.26079 12.5379 18.7153 -20.6967 6.08864 -3.03965 -1962 6 35.8475 14.1052 8.57203 -21.6385 -0.893463 -33.3774 -1963 4 35.1968 13.4152 8.63145 -9.00219 -13.9675 31.2536 -1964 4 35.5915 14.3843 7.67264 23.8052 12.2531 2.11843 -1965 6 9.47935 39.8135 37.5891 59.0759 6.31763 -30.1219 -1966 4 10.4266 39.6693 37.2666 -35.8633 -8.68454 26.4626 -1967 4 9.26489 40.5592 37.0217 -20.4655 -4.29881 5.22341 -1968 6 3.55142 30.3339 19.2713 -4.86381 -1.52132 15.3498 -1969 4 4.33638 30.9045 19.2209 2.57405 -7.87202 3.73908 -1970 4 3.61239 29.7873 20.0935 6.99099 14.0083 -17.3235 -1971 6 36.3358 32.3745 17.56 -88.747 -21.2483 -18.3477 -1972 4 37.1123 32.7301 17.855 71.5568 29.0637 22.2427 -1973 4 36.4955 31.7908 16.8209 7.92507 -6.87638 -5.35096 -1974 6 22.0663 24.5107 41.4102 10.2987 16.3962 12.7497 -1975 4 21.8202 25.2352 0.099599 7.35269 -2.74787 -1.24985 -1976 4 21.4331 24.5495 40.7007 -15.7672 -0.145359 -12.6123 -1977 6 45.7559 15.6146 11.6534 9.54961 -0.52573 -11.8143 -1978 4 46.6616 15.9476 11.7359 -2.85604 3.39399 3.95489 -1979 4 45.8337 14.6574 11.6049 5.18085 -12.4794 -2.56515 -1980 6 22.3677 20.3608 16.0248 -8.43349 0.762232 -3.33301 -1981 4 21.8453 20.4382 16.8206 -16.1556 -9.64869 10.2413 -1982 4 23.0114 21.0388 16.1556 20.3116 20.3082 3.24798 -1983 6 25.8272 25.7408 18.9039 -4.38174 23.1082 -8.64826 -1984 4 25.2526 26.4897 18.6396 10.1677 -11.9346 2.39614 -1985 4 25.327 25.3554 19.6213 -1.60311 -10.6753 3.35926 -1986 6 35.3217 34.2027 33.2895 -15.2368 -41.9721 4.95923 -1987 4 35.4982 35.1152 33.2737 3.10328 43.0158 -1.14622 -1988 4 34.4946 34.1251 33.8 0.780353 -3.85018 -10.6306 -1989 6 39.2773 17.1161 17.3873 -13.1248 -32.2738 -8.05101 -1990 4 39.9918 17.6798 17.5739 28.094 23.6652 8.23643 -1991 4 38.688 17.6273 16.829 -11.1713 3.07886 5.75329 -1992 6 0.390078 14.9382 21.7871 11.1367 4.76555 -0.935352 -1993 4 54.4387 14.8735 21.5807 -4.47162 2.48431 -1.07762 -1994 4 0.539841 14.2564 22.4568 -0.558284 -6.24417 -4.29591 -1995 6 15.9777 23.2264 17.7728 8.65625 13.1041 -6.34263 -1996 4 15.4566 22.9884 16.9791 5.52796 1.00784 5.82867 -1997 4 16.2806 24.159 17.6616 -10.6082 -13.1932 5.11686 -1998 6 5.23931 11.1231 17.5575 35.8701 -10.5445 17.9772 -1999 4 4.9182 10.2425 17.6538 -30.0926 -10.858 -8.95801 -2000 4 6.0864 10.9521 18.0214 -7.64643 27.0942 -5.06777 -2001 6 9.32885 36.7248 13.2722 18.9931 -22.2768 -8.23823 -2002 4 9.60165 35.7781 13.2295 -3.69965 14.6724 -0.704445 -2003 4 9.76236 37.1699 12.5317 -7.58045 -2.70049 0.515103 -2004 6 25.4778 33.5648 0.584885 -10.5355 67.2754 -12.4068 -2005 4 25.5984 34.5208 0.879361 -11.6997 -30.6233 -9.64051 -2006 4 26.086 33.1118 1.1181 20.4991 -31.2317 29.3626 -2007 6 17.3118 24.383 31.3319 -1.28664 6.54307 -2.76395 -2008 4 17.7194 25.1777 30.9449 -5.40799 -4.17061 0.343513 -2009 4 16.6541 24.6578 31.9842 -4.89885 3.77294 -0.581941 -2010 6 50.5608 32.7082 27.7934 4.54158 -2.94952 -18.7634 -2011 4 50.7453 32.9177 28.6973 0.494052 11.2961 18.8161 -2012 4 49.6536 32.9735 27.676 -15.0266 -0.0998574 -2.84245 -2013 6 2.26734 37.236 16.1173 -6.42813 -12.7591 -21.9136 -2014 4 3.23226 37.3187 16.1136 -7.03488 -2.64717 4.42174 -2015 4 1.90002 37.4962 16.9584 8.86323 8.39289 12.7736 -2016 6 25.781 33.1953 8.40059 -29.5389 -21.3471 9.61313 -2017 4 24.912 33.1588 8.86731 13.6407 4.32372 -10.5279 -2018 4 25.7521 32.4014 7.84509 3.14784 4.30114 -1.53431 -2019 6 24.7803 7.83271 25.42 33.5144 32.018 13.9598 -2020 4 25.5535 8.29724 25.0002 -28.4293 -10.6828 16.5011 -2021 4 24.3491 7.42211 24.7041 -24.9556 -17.4551 -27.4815 -2022 6 44.0168 27.3303 21.5604 -2.1935 -26.0293 -25.9567 -2023 4 43.1804 27.7287 21.7105 -15.5436 25.6402 11.6584 -2024 4 43.7182 26.5374 21.0766 16.4483 6.01939 6.04345 -2025 6 20.8314 32.075 6.72772 34.1297 -23.9008 -4.85338 -2026 4 21.613 31.4679 6.7544 -19.7741 14.5872 -14.4381 -2027 4 20.6476 32.1788 7.6576 -7.69651 14.1485 11.3249 -2028 6 0.619789 26.0994 3.99415 -10.3518 14.1264 10.767 -2029 4 0.887335 25.4928 3.30986 5.36048 -13.1936 -7.97543 -2030 4 1.24971 25.9998 4.71308 0.85353 -1.82089 -1.56654 -2031 6 23.69 0.227417 22.8544 35.0871 1.11343 17.3571 -2032 4 23.3906 1.11513 23.0752 -8.28129 -2.57498 -6.74336 -2033 4 24.6181 0.214091 23.2237 -29.0994 -2.98435 -11.3486 -2034 6 35.6339 26.9438 6.46453 10.8918 50.3879 3.14258 -2035 4 36.2586 27.0344 7.19591 -3.09793 -24.7425 -0.485193 -2036 4 35.6905 27.8753 6.10871 -13.1004 -35.3011 6.52721 -2037 6 50.1792 7.09321 18.6927 -10.3798 0.485236 0.91939 -2038 4 50.7755 7.39768 17.9917 2.23399 -7.26744 -1.07457 -2039 4 49.6856 7.89728 18.8977 2.66313 1.30029 -2.34319 -2040 6 12.4725 14.8259 12.1994 -11.4238 -12.6169 14.8051 -2041 4 11.6664 14.488 12.6556 18.5487 5.78377 -7.93059 -2042 4 12.1518 15.362 11.4889 -6.75978 6.85562 -13.2996 -2043 6 52.4644 22.357 36.3266 1.29806 9.96622 10.4358 -2044 4 51.6029 21.898 36.3064 11.3287 0.910024 -15.7837 -2045 4 53.0734 22.0059 35.6434 -17.6122 -2.36697 5.80151 -2046 6 41.7741 11.4843 39.1248 -4.39753 -8.31887 -97.8346 -2047 4 42.1028 11.6824 39.9378 27.3537 17.7413 77.2645 -2048 4 42.4804 11.7867 38.4877 -22.5072 -9.73773 16.9601 -2049 6 13.8016 22.5118 39.1095 -61.9889 -17.7515 -30.6487 -2050 4 12.8197 22.2903 39.2632 45.6803 12.2331 1.0283 -2051 4 13.898 22.318 38.1378 10.5436 5.15112 27.5343 -2052 6 28.757 19.5278 21.8422 22.1809 -34.574 6.30338 -2053 4 29.5381 18.8977 21.7155 -30.335 22.4331 6.48321 -2054 4 28.5907 19.9346 20.9925 4.65837 4.37905 -10.6157 -2055 6 8.3499 21.6369 36.3971 -4.18721 -6.14707 -6.4426 -2056 4 8.67403 22.5346 36.3601 -3.60933 11.4321 4.1017 -2057 4 7.70004 21.5677 37.1222 1.54916 7.87236 -6.53046 -2058 6 39.9526 23.9745 15.2115 13.6309 -13.3423 -31.903 -2059 4 40.8439 23.5703 15.3899 -24.3155 14.8143 -11.3375 -2060 4 39.7878 23.9253 14.2154 4.70535 3.62281 36.021 -2061 6 8.1527 38.6897 22.5283 9.69445 13.3876 41.2978 -2062 4 7.76273 39.4363 22.0797 -11.7526 5.15604 -12.9046 -2063 4 8.4358 39.1168 23.3873 -5.25998 -17.8667 -18.7912 -2064 6 10.8496 20.1728 28.9641 16.4592 -1.26099 15.6701 -2065 4 9.98954 19.7606 29.0198 -7.88942 -4.93169 1.40711 -2066 4 10.9743 20.477 28.0788 -3.54014 6.836 -18.3013 -2067 6 36.8958 23.8215 41.8184 -11.2791 50.4956 -15.8947 -2068 4 37.6092 23.2626 0.106032 31.5333 -36.7229 14.8491 -2069 4 36.0533 23.398 41.8576 -15.1401 -19.7994 6.87638 -2070 6 23.7844 40.6753 33.3645 25.4398 -8.90266 -26.6636 -2071 4 23.0047 40.9559 33.8219 -17.4738 3.31201 10.6553 -2072 4 23.8864 39.707 33.5122 -4.88896 17.7845 5.86364 -2073 6 4.67086 19.2968 35.4027 23.2175 14.2952 24.1117 -2074 4 5.52557 19.1329 35.8895 -25.1286 -0.194605 -14.6261 -2075 4 4.47498 18.5363 34.8535 5.06934 -11.7578 -4.1199 -2076 6 9.45318 25.7818 10.8943 -12.0967 -8.54473 -2.48434 -2077 4 9.17249 24.8577 10.8042 5.18757 -1.88658 7.00696 -2078 4 8.69489 26.2739 10.5541 4.04726 3.8113 4.64502 -2079 6 27.2856 22.4903 13.6084 -4.27813 -9.26261 -11.4963 -2080 4 27.1477 21.7546 14.2243 0.799228 0.372191 -1.31996 -2081 4 27.4324 22.0688 12.7356 2.14896 10.5831 15.5277 -2082 6 41.0369 18.7679 23.2817 21.3973 -17.1333 -11.6606 -2083 4 40.4805 18.1775 22.7581 -1.93352 7.79722 7.02989 -2084 4 40.5302 19.4817 23.6332 -16.07 12.1618 6.58845 -2085 6 46.4867 28.3511 20.139 19.5633 -2.73425 79.1757 -2086 4 45.7489 28.0125 20.7058 1.11057 9.83041 -23.9354 -2087 4 47.2126 28.3766 20.859 -22.6454 6.05643 -47.0217 -2088 6 14.8422 15.3983 30.0672 9.57922 -13.7488 21.5316 -2089 4 14.7114 15.4303 29.1407 -5.18406 2.12307 -31.6519 -2090 4 14.4223 14.5569 30.327 1.67929 11.6926 7.32181 -2091 6 23.5155 24.7614 35.2027 10.8097 10.1661 11.7756 -2092 4 22.8249 25.3921 35.4883 8.74662 -8.07224 -2.50931 -2093 4 24.264 24.8574 35.8273 -14.1502 1.20627 0.95778 -2094 6 19.9045 24.2066 28.4368 -7.08314 38.6572 -15.5481 -2095 4 20.1199 25.09 27.9887 -7.53461 -31.417 18.3002 -2096 4 18.948 24.2479 28.615 8.77669 -1.27719 -1.90381 -2097 6 45.9703 7.63062 20.2339 -9.12647 -14.8446 45.7383 -2098 4 46.0314 7.87281 21.2057 4.66889 -10.1155 -32.2433 -2099 4 46.2124 8.39508 19.7344 6.23892 21.3693 -9.48098 -2100 6 38.0366 12.4686 8.28298 -82.8488 23.4696 -21.0017 -2101 4 37.3097 13.1608 8.47894 48.7672 -25.4087 1.47773 -2102 4 37.4891 11.9231 7.63396 42.6716 2.94367 19.7224 -2103 6 46.9352 18.181 8.45984 -29.3266 9.95329 16.0714 -2104 4 46.1825 17.5598 8.49993 9.84889 1.25457 2.04897 -2105 4 47.3911 17.9594 7.65971 14.7535 -7.6497 -21.4463 -2106 6 10.8592 13.9727 9.37152 -3.14543 -2.30259 -2.26695 -2107 4 10.3309 14.6626 8.91794 11.6563 -8.1882 2.6931 -2108 4 11.7607 13.9013 8.99546 -12.5287 13.781 2.06755 -2109 6 34.3902 5.43491 14.0826 12.6346 -17.837 -1.14204 -2110 4 35.1666 5.80709 13.6695 9.45544 21.1547 -1.41353 -2111 4 34.3397 4.58795 13.6148 -10.7305 -5.41844 9.88093 -2112 6 0.19016 0.223418 22.9526 3.77382 -24.7853 -3.01602 -2113 4 0.21308 41.6498 22.1069 2.59646 7.80057 12.2766 -2114 4 54.882 1.08863 22.7473 -12.4607 27.7599 -7.08256 -2115 6 40.9349 30.5562 37.8906 -27.573 -19.5948 34.9696 -2116 4 40.0494 30.8463 38.2359 23.4276 0.414778 -20.0189 -2117 4 41.1198 29.7844 38.4793 13.2677 19.1991 -19.1849 -2118 6 16.6358 17.3088 12.6818 26.7235 26.3695 -9.20965 -2119 4 16.2617 16.4703 12.4231 -8.92935 -8.7699 -0.695474 -2120 4 17.0088 17.6771 11.8494 -7.35458 -7.68048 15.4997 -2121 6 29.681 5.43286 24.7605 9.99716 1.48249 -7.0405 -2122 4 30.3348 5.91815 24.2382 -0.696307 0.629534 -2.6419 -2123 4 30.0075 5.55596 25.6632 -4.07672 -1.78023 1.29455 -2124 6 49.8902 0.287541 27.2058 21.9743 -13.7053 4.20571 -2125 4 49.8511 0.519591 26.2742 -5.37584 5.48457 -4.26768 -2126 4 50.7946 41.8257 27.2858 -12.157 4.98657 1.57708 -2127 6 31.2412 31.7366 15.2127 13.4193 29.9729 -4.01619 -2128 4 31.644 30.8863 15.3566 3.05611 -13.2507 6.82249 -2129 4 31.9953 32.37 15.1128 -22.0385 -12.9049 3.52444 -2130 6 35.7903 24.1511 16.9464 13.6459 1.10276 -6.74723 -2131 4 35.6731 24.9832 16.4455 1.01595 -13.8109 1.97492 -2132 4 36.7089 23.8312 16.7527 -22.9866 2.97508 8.81266 -2133 6 24.2751 4.63968 36.7374 -16.5997 -22.3051 -33.4925 -2134 4 24.7608 5.22686 37.2962 14.6544 10.0168 10.4919 -2135 4 24.7016 4.68474 35.8573 -7.94113 -0.389021 16.9181 -2136 6 17.5636 12.9031 3.65869 27.6744 1.86844 -28.0383 -2137 4 17.6858 13.5605 2.94059 1.9993 -16.4932 11.4828 -2138 4 16.8984 13.3068 4.18363 -27.8054 1.98581 18.3397 -2139 6 4.17446 14.2934 18.2709 12.2351 -24.5699 -15.5283 -2140 4 4.25201 13.3082 18.1842 -5.45348 23.7329 4.34334 -2141 4 3.28482 14.5076 18.5604 -13.4286 -3.54266 5.37394 -2142 6 19.1793 36.8557 22.3908 -6.26797 4.12828 -2.16449 -2143 4 18.7803 36.3059 23.064 -4.74301 -7.71326 18.3965 -2144 4 19.5341 36.2254 21.7686 7.87239 -11.0625 -9.31555 -2145 6 15.659 11.9578 13.1999 9.98626 24.0921 3.91449 -2146 4 15.6233 12.8387 12.7526 3.08695 -23.3335 12.0049 -2147 4 16.532 11.8904 13.6603 -13.5492 -1.68197 -15.0215 -2148 6 24.7583 21.9129 5.36621 -52.0449 4.43235 28.4012 -2149 4 24.9756 21.6947 6.28233 10.5491 3.37037 -1.58044 -2150 4 23.7611 21.9216 5.43181 35.5612 -5.35731 -13.8865 -2151 6 52.741 18.5708 35.2268 19.1809 2.02674 5.12186 -2152 4 52.5591 18.101 34.4104 -23.468 -7.47943 -3.72799 -2153 4 51.9957 18.6447 35.8177 -20.5936 -5.49273 0.0575333 -2154 6 3.56038 27.2788 25.2921 -16.6903 -17.6792 -11.4043 -2155 4 3.96469 27.2185 26.149 7.10467 -3.13705 18.347 -2156 4 3.97939 27.9962 24.8424 10.8751 21.6711 -8.62461 -2157 6 34.4448 32.9974 30.68 48.2331 9.00339 -1.41906 -2158 4 33.5189 32.8245 30.8394 -9.09046 9.48004 8.12592 -2159 4 34.8804 33.6211 31.3233 -29.3839 -17.782 -5.29467 -2160 6 35.2611 23.7526 9.83248 5.28039 9.63542 14.9856 -2161 4 34.4624 23.9143 9.32096 3.45609 1.41047 -6.97204 -2162 4 35.624 22.9154 9.5528 3.26088 -11.8232 -8.34585 -2163 6 42.4243 15.7233 8.97763 12.8326 1.39623 12.6931 -2164 4 41.658 15.328 8.60072 -22.8346 -8.994 -22.1277 -2165 4 42.104 15.9534 9.85586 1.77226 3.68974 5.84069 -2166 6 7.76866 28.8533 32.9548 -11.0049 17.2013 -15.4709 -2167 4 8.04862 28.1203 33.4848 1.42969 -15.0059 16.0601 -2168 4 8.50079 29.0495 32.3677 8.58058 4.20069 -3.59376 -2169 6 17.6953 41.2515 36.4663 -11.3067 -18.3758 74.5383 -2170 4 16.8889 41.7296 36.6796 -1.19906 6.43806 -6.60961 -2171 4 17.8689 41.3412 35.574 12.2332 11.1792 -57.8962 -2172 6 28.5157 24.2416 15.5518 -29.4686 -13.3801 -11.1317 -2173 4 29.0166 24.9984 15.2559 10.2779 3.66755 -9.57255 -2174 4 28.1226 23.7858 14.7645 18.214 7.11075 11.8426 -2175 6 20.955 16.2999 1.15679 52.4547 14.172 -5.31351 -2176 4 20.9215 15.3848 1.33551 1.21723 -32.5558 11.4722 -2177 4 20.0795 16.5686 1.08505 -57.8144 13.7968 -3.85053 -2178 6 31.1684 40.7359 5.3086 9.60886 -48.7905 -14.3252 -2179 4 30.3201 40.4364 4.96776 -1.1434 5.1051 1.34806 -2180 4 31.1111 41.6485 5.46945 -11.8258 44.905 11.395 -2181 6 29.926 24.7744 36.4585 -3.76808 18.8348 4.26027 -2182 4 30.4252 25.4661 35.9713 -7.21832 -13.6313 5.02454 -2183 4 29.9738 23.9763 35.9568 8.68635 -20.1437 -13.5665 -2184 6 8.66863 31.0429 3.90108 5.49181 -25.3701 -11.391 -2185 4 7.74616 30.7992 3.95988 -7.56137 -0.630176 -1.16432 -2186 4 8.75287 31.8877 4.30735 2.25384 31.6916 10.4967 -2187 6 5.52708 32.7014 11.4113 -17.1068 -29.6258 4.38787 -2188 4 4.72561 33.1583 11.715 12.8879 6.23598 -5.09299 -2189 4 5.16474 31.7796 11.3163 19.6841 23.1791 1.24929 -2190 6 45.6525 35.4522 20.4433 4.50188 -15.2767 -13.8779 -2191 4 45.1533 35.403 19.6071 0.884587 3.9764 11.125 -2192 4 46.1815 34.6145 20.4501 -8.61117 18.3435 2.22997 -2193 6 19.5135 2.78077 9.78076 -23.679 -24.2198 -16.6656 -2194 4 19.3296 3.70289 9.60293 -7.62346 7.89228 3.64078 -2195 4 18.7563 2.26696 9.35595 24.4568 20.2801 14.4664 -2196 6 54.9521 9.08257 10.915 1.41457 -13.8994 3.08946 -2197 4 54.8451 8.89609 11.8656 1.69601 3.75098 -5.72792 -2198 4 0.659909 9.73404 10.7859 1.63405 2.05096 5.26063 -2199 6 21.028 26.5613 14.7909 22.3934 -16.1712 -61.6784 -2200 4 21.2545 26.1082 13.8887 -5.63248 33.4215 43.8962 -2201 4 20.0757 26.5096 14.8457 -4.66041 -4.09977 8.40724 -2202 6 14.1565 30.5187 27.5481 43.0568 3.88252 13.2649 -2203 4 14.5478 30.2647 28.4319 -11.7888 3.54471 -30.6513 -2204 4 14.9443 30.8429 27.0102 -33.9181 -6.53128 14.6047 -2205 6 29.8147 17.3367 31.0866 -27.8518 -4.92818 12.2149 -2206 4 30.6554 17.4646 30.6741 20.9401 8.7355 -10.9161 -2207 4 29.248 18.1063 30.9142 12.1966 -0.59561 3.44929 -2208 6 50.8794 17.2985 27.8251 -38.7154 2.44379 -6.74856 -2209 4 49.927 17.6315 27.8951 41.9068 -8.6615 -2.42711 -2210 4 51.4551 17.8493 28.3603 -3.47276 2.02156 5.1771 -2211 6 46.2645 37.0852 13.9854 4.42941 -15.3994 -45.1385 -2212 4 46.1048 37.4162 14.8449 -7.65894 23.339 32.9902 -2213 4 45.682 37.569 13.3645 -0.578519 -6.08013 10.2779 -2214 6 38.1859 37.2676 33.1408 3.52211 -11.0724 24.5555 -2215 4 38.5393 37.4103 34.0404 -6.68303 -10.0954 -6.88307 -2216 4 38.6219 37.9461 32.6369 2.42637 17.4604 -15.0111 -2217 6 41.8357 13.3473 31.1178 -16.0625 23.8584 17.742 -2218 4 41.5851 13.9423 31.8754 7.82637 -22.3228 -20.2899 -2219 4 42.4009 12.6411 31.4368 6.59024 -10.1979 3.85371 -2220 6 46.9027 12.6459 17.8387 -27.1897 30.7666 -32.0186 -2221 4 46.619 13.5972 17.8049 11.7948 -22.8605 3.48595 -2222 4 46.5208 12.2901 16.9886 18.0608 -3.03081 22.7278 -2223 6 32.0582 10.0955 10.6527 -31.4378 50.3229 23.4622 -2224 4 31.7762 9.76632 11.5317 8.81554 -8.40176 -19.9459 -2225 4 31.6698 11.0464 10.7004 29.7372 -48.0302 -12.3835 -2226 6 34.0062 11.3773 6.75186 17.7871 30.589 25.6979 -2227 4 33.4869 10.5999 6.69262 -19.6684 -30.9606 -3.70709 -2228 4 33.8274 11.7035 7.66069 0.227829 -0.558148 -16.2574 -2229 6 45.3288 30.8634 19.4834 2.25993 -0.395596 -7.26595 -2230 4 45.2654 30.706 20.4282 2.85912 -9.1252 8.63447 -2231 4 45.808 30.1003 19.1195 -1.86475 4.39364 7.74954 -2232 6 20.3535 0.575918 7.15275 2.53913 19.7072 2.1264 -2233 4 20.3036 0.62077 8.11765 -6.02971 -5.31178 -3.74759 -2234 4 20.3373 41.5708 6.90351 -3.42232 -20.4047 0.354773 -2235 6 15.9901 39.4523 4.14302 -22.6863 14.3541 -4.96379 -2236 4 15.4898 39.956 3.48033 13.9059 -6.08345 -3.0001 -2237 4 15.6535 39.8695 4.95456 5.06581 -11.7067 3.21286 -2238 6 52.4222 16.4823 25.1021 7.38571 -14.026 0.748627 -2239 4 51.9391 16.8928 25.8315 -3.23714 5.96419 -6.435 -2240 4 52.4547 17.0876 24.3371 -9.72126 -3.91711 12.1205 -2241 6 38.5305 12.9945 3.24722 36.6577 77.8042 9.91619 -2242 4 38.7269 13.7231 3.96388 -16.2716 -45.5952 -32.5571 -2243 4 38.0745 12.2732 3.61889 -23.0516 -27.5087 18.4748 -2244 6 35.1404 29.6968 31.1683 -32.7778 -10.63 75.6098 -2245 4 35.326 30.1595 30.3922 19.5999 28.8984 -42.5223 -2246 4 34.769 30.3505 31.8393 8.36493 -22.8372 -28.4638 -2247 6 9.52941 33.7628 4.86075 -28.4918 10.8311 18.4951 -2248 4 9.24769 34.3211 5.62607 6.24621 -9.23174 -22.6788 -2249 4 10.3628 33.3905 5.10095 17.2263 -8.07265 -0.549435 -2250 6 21.5384 22.0668 20.5377 -8.24916 -13.7408 18.0665 -2251 4 20.8389 22.6833 20.2982 1.69112 5.82217 1.92954 -2252 4 21.3229 21.7148 21.445 5.44386 11.4228 -26.5573 -2253 6 37.5752 11.1922 41.2961 -25.7405 -15.8592 15.4541 -2254 4 38.0284 11.8044 40.7564 10.4246 30.4728 -30.151 -2255 4 38.2644 10.586 41.5433 15.0535 -11.8566 15.4014 -2256 6 33.8981 1.42806 38.7459 -9.94409 -6.93964 -8.18458 -2257 4 33.592 0.608166 38.3248 2.39341 2.703 9.2739 -2258 4 33.9534 1.28552 39.7002 -3.4763 3.29487 -4.45631 -2259 6 4.57081 26.6822 28.0049 6.08842 -57.033 -35.5124 -2260 4 5.0914 25.8197 28.0746 -15.9746 40.4578 4.78317 -2261 4 4.85783 27.3427 28.6052 16.6445 16.915 24.1865 -2262 6 10.2586 0.903759 11.6235 -14.777 -30.5961 35.2813 -2263 4 10.598 1.12099 12.5147 -1.53351 -1.03605 -18.7158 -2264 4 10.5217 1.55247 11.0069 12.731 34.1315 -22.4253 -2265 6 17.6428 19.8087 2.34625 28.3489 11.7442 10.4095 -2266 4 17.8694 20.4455 1.65312 -0.920106 -2.92675 2.15413 -2267 4 18.5186 19.4679 2.66241 -18.7748 -2.39069 -7.57655 -2268 6 32.4269 25.6656 16.4745 -22.7384 46.4686 12.005 -2269 4 32.9526 26.0936 17.1754 -0.693509 -13.2017 -11.5041 -2270 4 32.8268 24.9018 16.1119 18.5502 -33.1172 -3.66835 -2271 6 33.2526 10.6326 0.323883 9.44704 -29.8166 -9.67306 -2272 4 32.8511 9.97264 41.5994 12.5609 21.6724 15.7642 -2273 4 34.1113 10.2426 0.662313 -26.6835 12.0422 -7.05376 -2274 6 4.94395 4.51414 10.1428 13.8645 5.4827 29.102 -2275 4 4.09398 4.95549 10.181 -4.94694 -3.34603 -2.54834 -2276 4 5.29018 4.56097 11.0773 -8.61071 -3.77852 -28.7481 -2277 6 27.0981 16.9726 9.55361 -31.982 10.5528 -14.2027 -2278 4 27.1645 17.5497 10.32 4.78099 0.707575 6.97209 -2279 4 26.2221 17.2303 9.15822 25.9284 -7.90001 11.4222 -2280 6 9.97547 10.5192 19.3751 2.18725 8.20489 55.882 -2281 4 10.4385 9.92127 18.8097 14.3325 -20.7925 -15.5795 -2282 4 10.1136 10.195 20.3283 -2.00877 10.2565 -41.5362 -2283 6 19.5726 8.5313 27.8509 32.1681 -5.32712 19.6321 -2284 4 20.0623 8.73326 28.6965 -13.9453 -3.32017 -28.6613 -2285 4 20.1531 7.88958 27.3718 -16.7413 15.1406 10.2365 -2286 6 47.0715 38.9553 23.1297 -19.9487 1.16408 5.20576 -2287 4 47.6755 38.9992 22.3956 6.55525 -5.77104 -8.99339 -2288 4 46.1921 38.7934 22.7438 5.29072 4.97192 1.21114 -2289 6 19.6864 25.3648 11.2698 -35.9279 -4.62509 3.50742 -2290 4 18.9891 24.6498 11.3772 26.0807 25.4649 -7.71219 -2291 4 19.2193 26.1995 11.535 7.74761 -20.7647 -6.77192 -2292 6 27.3916 13.4622 15.7395 34.9583 -25.2468 -27.4167 -2293 4 26.6227 13.8144 16.1317 -23.8298 14.7279 29.1585 -2294 4 28.0863 13.1847 16.3728 -7.05347 8.15442 -0.924368 -2295 6 18.6718 14.1326 1.43279 -0.407031 -28.5308 -28.57 -2296 4 18.3771 15.0354 1.29678 -0.169849 11.7565 -8.38297 -2297 4 19.1904 13.8513 0.615983 -22.2167 19.1803 27.2908 -2298 6 42.3082 22.0346 32.4819 -45.1257 5.10199 -13.868 -2299 4 42.1064 21.5657 33.301 1.02444 -1.81924 7.74271 -2300 4 41.4227 22.4584 32.2639 35.231 -14.359 4.36271 -2301 6 10.0299 9.44853 2.50633 35.8335 -20.1603 -5.5533 -2302 4 9.22808 9.80314 2.87263 -22.9312 8.40439 12.9687 -2303 4 10.3707 8.71125 3.07205 -18.436 14.324 -8.13067 -2304 6 6.82989 1.45163 22.0085 -48.1074 -31.7833 -34.6048 -2305 4 5.93364 1.52189 21.5813 27.761 13.2569 19.2226 -2306 4 6.99793 0.508973 21.801 12.0554 14.7409 9.93393 -2307 6 11.2802 27.0298 18.9733 1.62982 48.8223 -5.8971 -2308 4 11.8533 27.1031 19.7597 -5.53045 -6.49976 -4.21856 -2309 4 11.2066 27.9871 18.6476 2.337 -33.8373 14.078 -2310 6 41.4807 20.5084 27.2133 -10.1157 30.3313 5.28758 -2311 4 41.6238 21.1535 27.9303 0.1153 -0.646751 -15.7402 -2312 4 41.3475 19.7242 27.7174 2.20222 -28.2193 4.24429 -2313 6 15.4457 24.115 33.4309 -8.0908 -15.9975 4.96928 -2314 4 14.6694 24.1264 34.0087 5.2648 16.329 -3.20307 -2315 4 15.6051 23.1634 33.3621 10.6851 2.75783 3.25666 -2316 6 36.1374 16.3773 10.0083 -2.95201 1.72364 21.0093 -2317 4 36.0354 15.4723 9.6971 0.275369 -1.57281 -6.84486 -2318 4 36.1532 16.3058 10.9756 2.3103 1.89663 -9.38056 -2319 6 51.7249 16.2592 2.09899 -0.8354 -35.479 4.00209 -2320 4 51.3025 16.6477 2.84061 -15.4293 29.383 24.1936 -2321 4 51.7588 15.3279 2.40044 5.70816 13.7616 -13.313 -2322 6 23.409 8.55726 39.7719 39.5062 -11.15 -25.6965 -2323 4 23.7264 8.82822 38.8637 -18.295 -2.70527 32.3134 -2324 4 24.154 8.00621 40.1033 -17.8621 14.2471 -2.43096 -2325 6 36.7611 34.4487 21.1056 -9.59584 -7.71653 -9.58874 -2326 4 37.1943 34.5847 20.2534 -2.45984 1.11901 0.357954 -2327 4 35.8017 34.351 20.9183 13.0848 5.20904 4.89404 -2328 6 14.146 8.88688 27.2949 11.3522 43.6232 -16.453 -2329 4 13.5534 8.17113 27.3093 -27.716 -37.4722 8.68734 -2330 4 15.0033 8.5993 27.5988 11.0136 -4.6565 4.44913 -2331 6 20.6652 37.4903 25.1946 -10.211 -17.9881 -36.0994 -2332 4 20.7454 36.6557 24.6643 4.11278 14.2078 23.4923 -2333 4 20.5382 38.1243 24.4693 3.50396 4.35638 18.4557 -2334 6 28.825 24.4792 30.0383 -7.87557 -12.5525 -14.3175 -2335 4 28.2203 24.3409 29.2957 -5.62902 14.2643 8.72595 -2336 4 29.6177 24.0933 29.6588 14.1928 -3.34691 9.72359 -2337 6 8.38024 12.0023 23.6849 17.6034 -17.8042 43.8798 -2338 4 9.33151 12.0391 24.0095 -25.5352 0.9508 -22.7134 -2339 4 7.93543 11.4413 24.3789 8.15752 13.9726 -18.9857 -2340 6 16.0957 26.6613 22.9482 -4.23776 -4.88874 3.00129 -2341 4 16.4041 25.8866 22.4682 2.11349 3.20317 -0.347462 -2342 4 15.2797 26.4088 23.4009 6.04671 4.79823 1.078 -2343 6 22.346 41.3881 9.48723 24.9275 -16.664 -2.62618 -2344 4 22.5706 0.299269 9.06271 5.87112 18.1013 -4.15908 -2345 4 21.5005 41.5154 9.87839 -30.5435 3.49176 4.55444 -2346 6 49.3776 19.1851 32.3736 41.1751 -38.6142 12.6649 -2347 4 49.9515 18.5305 32.8666 -19.8114 22.1793 -24.5398 -2348 4 48.9751 19.6643 33.0815 -18.7203 16.5505 12.5326 -2349 6 29.672 28.434 31.2292 -0.0990093 -59.7528 33.1636 -2350 4 30.5672 28.114 31.0525 8.33151 24.242 -15.2883 -2351 4 29.4026 27.6233 31.7702 -3.76231 36.9508 -17.5145 -2352 6 5.09757 39.1181 23.5694 28.9365 -16.8561 66.257 -2353 4 5.426 38.785 24.4883 -20.96 9.44698 -53.4069 -2354 4 5.17377 40.064 23.6953 -4.19226 13.7611 -6.16678 -2355 6 42.9396 13.594 41.6013 33.1291 -45.1938 12.1175 -2356 4 42.8466 14.3322 41.0449 -16.6361 37.6348 -21.2948 -2357 4 42.1546 13.3797 0.17078 -22.3633 5.8076 7.08965 -2358 6 21.2201 12.4318 7.37385 41.5974 -14.6934 -10.3279 -2359 4 20.2896 12.3563 7.35505 -36.2241 5.92132 -7.85999 -2360 4 21.5284 11.6004 6.96932 1.7608 11.2928 4.8084 -2361 6 43.1404 26.8989 37.6922 38.0431 -66.5876 34.8581 -2362 4 42.455 26.3454 37.3085 -15.3628 11.0452 -11.3741 -2363 4 43.7284 26.1839 38.1775 -25.099 52.0029 -25.4853 -2364 6 19.5406 10.6485 41.687 -7.00401 -34.9019 -10.1363 -2365 4 19.0738 10.6767 0.596923 -7.19888 -1.38148 21.2635 -2366 4 19.8536 11.5162 41.559 12.2515 43.5875 -9.13673 -2367 6 53.6223 10.061 3.2559 12.5469 7.56169 -12.6981 -2368 4 54.2024 10.8465 3.22155 -5.5124 -7.95383 7.8004 -2369 4 54.0687 9.40413 2.68363 -10.8512 12.6529 5.34221 -2370 6 17.5742 20.1926 28.4231 -27.2496 23.4973 23.4861 -2371 4 18.0413 19.6307 27.8376 17.787 -14.8025 -21.0857 -2372 4 18.1273 20.2938 29.2048 3.54631 -0.489564 0.0042962 -2373 6 36.884 7.32584 1.68504 -56.6071 21.2656 -14.3658 -2374 4 37.7051 7.59774 2.01592 38.2946 9.18211 20.2394 -2375 4 36.4748 8.1931 1.44071 3.42518 -20.8507 2.42249 -2376 6 29.2181 41.4159 1.83346 -7.01124 13.363 14.2223 -2377 4 28.4272 0.01466 2.15652 15.3791 -9.50345 -13.4545 -2378 4 29.1899 41.2946 0.880744 -4.61983 7.49126 -6.31737 -2379 6 13.5157 3.09172 8.12958 -12.3356 7.91728 -16.4605 -2380 4 12.824 3.78046 8.01164 12.4629 -9.10221 7.3254 -2381 4 13.8551 3.1491 9.02604 -1.1531 -1.24526 3.73064 -2382 6 15.0243 29.578 18.5071 -0.689822 5.1468 -1.91807 -2383 4 14.6889 28.924 17.8685 -1.8514 4.35612 11.642 -2384 4 14.2858 30.1508 18.7969 8.46412 -5.78667 -10.3485 -2385 6 10.5031 24.7013 24.3729 39.9308 52.3958 -21.489 -2386 4 10.8696 24.6855 23.439 -22.6214 -1.85919 30.3756 -2387 4 10.1444 23.8694 24.566 -23.1097 -44.7323 0.689524 -2388 6 2.33043 13.8499 25.1512 12.2217 -8.49201 10.1592 -2389 4 1.51988 13.5482 24.7402 -5.80441 -9.83551 -11.7005 -2390 4 2.2572 14.7938 25.1495 -10.3249 16.8303 -2.61333 -2391 6 31.8608 32.7615 29.8175 -5.917 1.92483 -13.0568 -2392 4 30.9148 32.9142 29.9093 1.86919 3.45723 4.06263 -2393 4 31.9038 31.8703 29.4643 1.33296 -6.10517 -4.90202 -2394 6 37.5413 40.8309 33.9785 -53.8639 -49.1526 -10.38 -2395 4 37.2515 40.0243 34.5353 23.0474 40.5808 -8.35317 -2396 4 36.818 40.8104 33.2846 24.4839 11.2763 19.2644 -2397 6 24.0486 38.1463 34.3459 4.38709 -25.8386 -29.9356 -2398 4 24.1932 38.0251 35.2675 1.20986 12.6476 31.9448 -2399 4 24.4562 37.3431 33.9843 -4.45208 9.66559 -5.62065 -2400 6 37.1813 22.5726 7.37313 12.7367 -26.0408 21.8779 -2401 4 37.6868 21.7363 7.50199 -14.9443 17.386 1.08188 -2402 4 37.2974 22.7741 6.46124 2.1827 3.60906 -24.8808 -2403 6 4.31908 23.2435 35.594 -25.7168 -2.52913 6.61784 -2404 4 4.31865 22.3787 35.1609 -1.33991 4.89576 -0.266123 -2405 4 3.37757 23.4898 35.7698 13.7393 -2.9658 -3.46645 -2406 6 15.7444 14.893 2.66063 14.3192 36.2435 46.5189 -2407 4 15.9445 15.8567 2.71494 4.00237 -25.0016 7.78932 -2408 4 15.3014 14.8369 1.84861 -12.1852 -13.1154 -36.1328 -2409 6 48.1607 23.1823 2.03014 17.998 -4.54201 -11.9107 -2410 4 48.5744 23.458 2.84259 8.43731 2.94545 12.5813 -2411 4 48.9225 22.9045 1.46682 -22.9697 5.41467 1.46601 -2412 6 24.1212 19.9771 21.5555 -13.5297 -6.85262 15.9953 -2413 4 24.2241 19.3198 22.2577 -12.7792 13.8262 1.69378 -2414 4 24.7627 19.6352 20.9706 23.452 2.79195 -33.2435 -2415 6 10.5793 29.3754 5.15175 -1.75103 26.9922 -14.4666 -2416 4 9.93004 29.8841 4.64694 -13.9608 -12.0643 5.47156 -2417 4 11.3599 29.8389 4.86113 16.4531 -5.21099 6.28998 -2418 6 5.96767 27.6933 31.2336 10.2296 -18.0279 -26.5205 -2419 4 6.63185 27.1353 30.7398 -17.0624 11.0978 13.8341 -2420 4 6.49058 28.2721 31.7915 6.44996 0.578865 12.7715 -2421 6 18.5397 25.8071 15.3312 30.8629 -17.2743 -78.9847 -2422 4 18.3277 25.7099 16.2038 -28.7942 6.39581 79.7195 -2423 4 17.897 26.3418 14.8644 -17.4943 11.9017 11.8989 -2424 6 52.0949 37.2335 11.1138 -0.736115 -25.1617 0.200807 -2425 4 52.5552 36.4743 10.7101 2.49656 11.0988 9.7325 -2426 4 52.7586 37.8745 11.3958 -2.29245 7.10647 -7.85035 -2427 6 46.8562 14.6296 7.3094 -39.0502 -6.9365 63.794 -2428 4 46.1382 15.0906 7.8718 34.2719 -4.68193 -40.7336 -2429 4 47.0431 13.9061 7.9424 14.2062 7.46383 -20.3992 -2430 6 22.2508 0.698906 41.6783 16.129 -5.34947 -25.8041 -2431 4 22.2008 1.66415 41.7125 4.72421 -6.65403 -6.59212 -2432 4 22.9559 0.389699 41.0229 -20.0941 20.4891 31.5318 -2433 6 4.05761 14.7345 9.27152 -10.7438 13.6286 -6.0443 -2434 4 3.56043 15.5915 9.15395 12.8436 -23.8424 -1.56379 -2435 4 4.93811 14.8828 8.92118 3.87558 5.66633 -1.10852 -2436 6 37.2917 12.6666 37.0157 -30.741 -16.0859 47.3668 -2437 4 37.7371 12.676 37.8973 0.89189 9.6387 -16.8975 -2438 4 36.3707 12.3712 37.2872 32.4569 8.65188 -22.8431 -2439 6 26.6682 29.0903 40.5985 -18.9168 16.4285 3.4146 -2440 4 27.032 28.2632 40.812 19.8197 -36.7417 16.2821 -2441 4 26.6469 29.0593 39.6552 2.37875 14.8387 -20.8034 -2442 6 7.22455 13.851 3.31845 32.6668 -55.3021 -17.7697 -2443 4 8.0198 14.2759 3.60088 8.05656 35.1068 9.02454 -2444 4 7.66854 12.9807 3.04146 -45.3946 28.1811 11.8363 -2445 6 8.95271 34.8627 28.8342 33.802 -52.1542 -15.9648 -2446 4 9.89817 35.0055 28.6074 -18.5208 0.484683 7.95646 -2447 4 8.56267 35.6958 28.9173 -17.8026 46.8286 13.0667 -2448 6 37.1756 40.0691 40.1061 46.0034 7.56439 6.60252 -2449 4 36.245 40.1688 40.0074 -20.2243 -4.13511 -1.70673 -2450 4 37.2907 39.5142 40.8911 -6.64471 -1.97244 -3.69085 -2451 6 30.3689 6.165 27.2364 16.9392 12.8422 63.3115 -2452 4 30.1126 5.75506 28.1249 0.00544273 9.78172 -37.0876 -2453 4 31.0397 6.83064 27.5702 -18.6179 -11.6186 -23.6342 -2454 6 10.4791 22.885 18.2972 2.22892 -25.7937 -34.5052 -2455 4 11.3494 23.0331 18.653 10.7715 4.73748 7.10061 -2456 4 10.6446 22.3032 17.5049 -10.188 21.0769 23.5682 -2457 6 35.8886 14.2524 40.1239 38.6938 29.9036 -1.43051 -2458 4 35.4161 14.6576 39.3846 -1.71718 -13.5804 13.4977 -2459 4 35.4021 13.6019 40.5864 -31.0402 -18.1501 6.5583 -2460 6 6.71723 1.08854 17.7001 -3.83901 -60.8198 25.71 -2461 4 6.23156 1.19942 18.5167 -3.21909 18.7445 0.671973 -2462 4 6.88149 0.099135 17.7878 0.895752 34.2898 -15.7018 -2463 6 41.3468 34.0461 33.1794 10.5682 19.0983 -18.7578 -2464 4 40.4721 34.2712 32.8864 -29.2649 -1.70533 3.43004 -2465 4 41.8357 34.5632 32.5195 11.425 -3.18121 9.05585 -2466 6 37.2595 0.990816 41.287 9.45411 17.3584 -9.40071 -2467 4 37.687 0.20533 40.9743 -1.4253 -22.058 -8.3634 -2468 4 37.4586 1.01742 0.30817 4.28067 1.92511 18.4856 -2469 6 25.2602 30.9527 6.20609 -41.9214 10.7977 -12.9978 -2470 4 25.877 31.4326 5.6764 28.9604 0.775163 -4.96937 -2471 4 24.4759 30.9469 5.60333 12.4846 -9.23957 25.2824 -2472 6 14.2056 24.502 28.3086 -25.5247 14.5131 -24.5719 -2473 4 14.1882 23.6623 28.7056 13.4522 -31.4953 30.087 -2474 4 13.7133 24.2842 27.5041 7.94148 19.2098 -3.82225 -2475 6 34.2051 26.2238 36.0112 -48.9031 41.3361 24.9979 -2476 4 35.1144 26.3624 36.1822 32.7561 -2.50775 4.45543 -2477 4 33.7446 26.9807 36.5344 19.2218 -36.9328 -23.3608 -2478 6 32.3568 8.33098 28 25.7802 40.2385 3.20277 -2479 4 32.7565 9.24505 28.063 -37.9579 -17.4528 3.85033 -2480 4 33.1461 7.94224 27.6538 8.5967 -27.8742 -9.28785 -2481 6 11.7867 0.286536 26.9724 -1.3913 -35.2382 4.72224 -2482 4 11.7865 41.2385 26.6946 0.846362 23.7064 4.93964 -2483 4 11.6054 0.272418 27.9282 2.03777 4.09428 -12.4872 -2484 6 1.68124 0.254113 10.3309 8.7986 -13.2184 -15.0921 -2485 4 1.59717 41.2916 10.7333 -0.0350141 -2.89412 -0.990995 -2486 4 1.41389 0.849687 11.0071 -7.7361 15.4014 20.6266 -2487 6 6.75173 13.8377 8.23874 -3.6693 30.6435 -30.4665 -2488 4 6.43924 13.9799 7.29904 9.51956 -14.6006 30.1073 -2489 4 7.1653 14.6974 8.43116 5.95594 -9.45057 4.81521 -2490 6 22.2348 20.5564 6.16471 -24.0844 -9.72934 13.195 -2491 4 21.6727 21.3518 6.25881 9.87637 -7.56006 0.262552 -2492 4 21.7029 19.8181 6.55593 11.5262 14.9976 -6.6436 -2493 6 17.385 20.4497 10.8769 -35.9329 27.9153 -37.8305 -2494 4 16.5515 20.156 10.4074 25.3596 -4.97581 21.0147 -2495 4 17.441 21.3848 10.5386 11.6957 -25.2138 21.3318 -2496 6 17.7006 4.52737 19.573 -11.3777 -34.9061 -6.08889 -2497 4 17.032 4.43128 20.2569 -5.49224 11.1956 3.68583 -2498 4 17.4813 3.72403 19.0236 15.4315 33.5846 4.92098 -2499 6 0.483339 18.1114 40.0861 11.4726 -7.5634 -25.4826 -2500 4 0.218803 18.6551 40.8031 -6.40406 19.3 17.6992 -2501 4 1.29471 18.4968 39.6981 -7.50073 -9.94226 4.45973 -2502 6 22.9439 24.8131 27.8304 -1.07592 37.7895 -56.3844 -2503 4 22.8309 25.5845 27.1671 -0.125595 -37.7338 24.1587 -2504 4 22.7938 25.2149 28.6606 -3.1997 14.6603 34.334 -2505 6 42.7926 39.1547 26.7662 4.75434 20.2168 6.00074 -2506 4 43.0175 38.5002 26.1242 -2.01943 -24.6309 -11.9253 -2507 4 43.3024 39.9142 26.4608 -1.73796 0.515913 11.2644 -2508 6 26.2338 3.05974 21.8008 -0.713756 21.3652 -6.58596 -2509 4 25.6341 3.75271 22.1513 17.432 -13.3686 -8.49125 -2510 4 26.841 3.50549 21.1637 -15.4189 -7.95734 10.2455 -2511 6 54.5913 9.88629 29.5891 14.6194 -0.200122 15.6168 -2512 4 54.0185 9.11016 29.6389 -2.18077 1.53735 0.0476299 -2513 4 54.8498 10.0557 30.5251 -12.748 -2.88746 -21.9109 -2514 6 24.7662 33.7505 20.5324 -4.4887 -11.5901 7.32024 -2515 4 24.6764 34.6709 20.8407 -1.82029 -5.26135 -2.53883 -2516 4 23.9322 33.4503 20.1388 -0.463927 12.2923 -3.35723 -2517 6 41.7034 16.3049 0.90063 -4.83399 22.4927 -47.1255 -2518 4 41.2734 15.9533 1.64089 -16.394 -13.425 40.883 -2519 4 42.6233 16.3659 1.12415 18.2298 -9.67465 4.77205 -2520 6 23.3998 27.9207 27.4832 -10.7606 37.0497 -28.3533 -2521 4 22.8282 28.3407 28.1441 5.00816 -9.79407 0.156118 -2522 4 23.2556 28.495 26.6632 8.58882 -24.5485 28.392 -2523 6 32.7859 37.2984 18.7364 25.7014 -40.2058 6.96479 -2524 4 33.7401 36.9719 18.7703 -32.5146 22.7172 4.70252 -2525 4 32.7784 38.1932 18.4283 6.4981 19.1078 -10.0488 -2526 6 21.2249 27.6889 4.78917 1.7584 -25.2435 -20.8654 -2527 4 20.596 27.4146 5.46499 -5.42949 1.48454 -4.75098 -2528 4 21.0369 27.1287 3.96943 -0.427807 22.4392 26.4825 -2529 6 54.9457 17.9605 1.83049 24.1732 12.1415 15.992 -2530 4 54.6765 17.1472 1.44643 -11.2843 -21.2768 -12.0273 -2531 4 54.1938 18.5428 1.86671 -18.1074 1.0363 -7.50679 -2532 6 36.7435 10.702 6.59289 -49.1612 2.30359 2.88264 -2533 4 35.7736 10.9925 6.66913 36.3355 -9.83622 -8.29906 -2534 4 36.7226 9.77144 6.87602 6.19961 4.27664 0.325158 -2535 6 54.2959 4.49421 14.021 -47.0247 26.1641 -8.2037 -2536 4 53.712 4.99768 13.3924 28.2438 -8.88077 8.93165 -2537 4 53.834 4.66365 14.8572 10.6634 -9.95324 4.36694 -2538 6 22.1071 12.8195 32.0067 31.7906 8.9597 -11.0311 -2539 4 21.2967 13.3066 31.9589 -27.922 0.108445 -0.906739 -2540 4 22.6887 13.2954 31.3728 -6.4895 -15.5456 16.1837 -2541 6 15.3021 36.6565 4.03444 -21.8215 23.8176 13.2077 -2542 4 15.3262 37.6185 3.88215 -1.10116 -7.72226 9.53853 -2543 4 16.0423 36.3695 3.52653 17.7184 -15.2462 -10.6327 -2544 6 23.951 1.27123 5.71091 12.3119 19.4094 13.4558 -2545 4 23.1735 0.716989 5.76524 -11.3354 -5.61231 -0.786433 -2546 4 24.0519 1.77027 6.55293 -6.00641 -12.6326 -15.7345 -2547 6 14.2792 12.648 15.8066 19.0644 9.13243 11.8341 -2548 4 14.5911 12.5731 14.893 -12.6174 -10.6299 -3.28453 -2549 4 13.3818 12.3002 15.9605 12.2346 2.97194 -15.7557 -2550 6 15.0388 40.2481 6.5891 -30.9219 -16.0267 -20.9978 -2551 4 15.8926 40.3583 6.97574 17.8619 16.6743 19.574 -2552 4 14.4622 41.0349 6.73493 18.0926 -11.8876 3.06612 -2553 6 48.5605 32.6308 12.0872 21.4935 -15.1737 -19.6402 -2554 4 48.2882 31.8163 11.6222 -11.7375 10.5522 8.8403 -2555 4 49.3772 32.8772 11.5869 -20.063 0.749688 13.0696 -2556 6 11.2909 31.5377 7.21713 -14.6129 -9.26005 -15.8818 -2557 4 10.6224 30.9548 6.78826 17.7824 9.96971 10.6082 -2558 4 11.6163 32.1134 6.50388 0.884245 -9.77636 6.63484 -2559 6 30.1231 27.9968 10.2226 9.10006 8.28679 -14.6513 -2560 4 30.718 28.7273 9.95045 -8.34799 -9.59518 10.9295 -2561 4 29.9727 27.4897 9.40845 -5.6962 -0.318113 1.27302 -2562 6 27.6759 22.1164 17.3809 2.93811 -8.1883 -22.8269 -2563 4 27.2909 21.5233 16.7142 1.55949 -2.9899 10.1125 -2564 4 28.0309 22.8242 16.8263 2.77593 4.45495 11.6125 -2565 6 12.9654 4.59514 18.1625 -0.934721 -11.3223 -0.518608 -2566 4 13.4589 3.798 18.4727 -12.2499 12.1104 -13.3514 -2567 4 12.4628 4.36939 17.3497 12.7979 1.84773 4.27522 -2568 6 19.7203 6.71654 19.0744 25.855 21.5282 16.2244 -2569 4 18.977 6.16103 19.2554 -18.9537 -21.446 -0.739234 -2570 4 20.1996 6.78409 19.9214 -9.72031 -0.922856 -11.6068 -2571 6 37.1527 31.3787 11.4669 20.5156 -3.08539 55.9419 -2572 4 36.5467 31.6235 12.1801 -19.4555 -0.126446 -17.2692 -2573 4 37.8531 31.0173 12.0578 -6.7166 -8.42047 -30.0342 -2574 6 3.11862 16.2015 27.3491 -14.8948 -19.7352 -9.46107 -2575 4 2.52427 15.4561 27.6487 20.3886 21.5408 -12.2486 -2576 4 3.15348 16.212 26.3649 -6.24389 -0.0501167 23.7097 -2577 6 15.7133 9.97724 38.3591 30.328 17.4212 13.8857 -2578 4 16.1258 10.8398 38.0549 -11.3336 -30.4403 16.2583 -2579 4 16.257 9.66317 39.1359 -16.0932 10.0631 -23.9552 -2580 6 13.4043 14.2884 8.2363 15.0986 25.1191 -5.83206 -2581 4 13.804 15.2225 8.33958 -5.13839 -47.7054 6.28407 -2582 4 14.0947 13.5837 8.31616 -11.6402 16.8216 1.41307 -2583 6 1.71524 24.3141 36.392 36.4901 -22.2748 31.9402 -2584 4 1.86474 25.1068 36.8985 9.35176 9.25273 5.49175 -2585 4 1.1215 24.6177 35.7571 -36.8309 10.6894 -41.0698 -2586 6 11.1862 26.5319 32.9688 15.239 -24.9993 36.2438 -2587 4 10.9649 26.8002 32.096 -11.5382 16.0703 -24.8314 -2588 4 11.1647 27.266 33.6054 -7.17864 1.89937 -11.754 -2589 6 29.5773 0.765668 36.2911 32.6527 8.9619 33.1448 -2590 4 29.1495 0.596705 35.4758 -23.483 -6.97315 -25.4485 -2591 4 28.9625 1.07408 36.9696 -5.35236 0.153158 -12.2969 -2592 6 43.6099 13.1071 23.908 -7.75428 16.7256 -33.2383 -2593 4 42.8302 13.3868 24.3919 -4.08537 -1.1131 9.93358 -2594 4 43.3622 13.2586 22.9511 7.4693 -9.27191 32.0602 -2595 6 7.44309 19.7767 19.6705 17.8438 12.6527 -6.23579 -2596 4 6.73015 19.1919 19.919 -3.61392 -10.9972 -0.189724 -2597 4 7.6227 19.7194 18.722 -11.1837 -0.704544 3.42764 -2598 6 24.4259 4.29913 7.83629 -8.5248 -0.10499 -3.36953 -2599 4 24.144 5.21077 7.98541 -0.150025 -7.47068 -3.31634 -2600 4 24.9904 4.0546 8.57206 4.90899 -0.271036 -1.18338 -2601 6 51.4883 30.2308 31.1674 -14.7545 1.56633 -0.747328 -2602 4 50.5925 29.8847 31.2768 -1.35209 3.55691 8.49804 -2603 4 51.5844 30.2463 30.2146 11.2248 2.3182 -11.9335 -2604 6 0.913373 23.6795 16.8764 44.9279 -35.4578 23.1065 -2605 4 0.053834 23.3329 16.7065 -24.7033 4.18361 -15.1926 -2606 4 1.39802 22.8443 17.1197 -4.68332 28.5423 -3.90241 -2607 6 45.0884 19.3939 15.6913 9.05154 29.148 -44.7311 -2608 4 45.9115 18.9543 15.4906 10.1171 -6.0821 0.331933 -2609 4 44.8041 18.9926 16.4702 -27.3917 -26.115 43.7395 -2610 6 17.5003 8.70625 40.5861 -20.5343 49.5779 -9.15489 -2611 4 18.1762 9.35755 40.8219 0.532033 0.318295 -4.52849 -2612 4 17.8864 7.89597 40.8225 20.4785 -39.0634 11.6529 -2613 6 30.1832 27.259 27.1983 -17.9859 30.5387 -1.70378 -2614 4 31.0843 27.5469 27.0174 5.19664 -5.65516 3.8328 -2615 4 29.6652 28.1124 27.2385 17.8651 -30.9588 0.0373123 -2616 6 43.0672 26.1987 28.3737 -1.21405 11.7795 -35.2128 -2617 4 43.2187 25.7399 27.5308 2.18298 5.51683 1.33219 -2618 4 43.1307 25.5038 29.0079 -1.74848 -11.3154 21.2466 -2619 6 27.987 7.5851 3.0601 9.13665 18.2748 23.7588 -2620 4 28.1896 6.93215 2.40721 -2.30749 -24.2619 -13.6918 -2621 4 28.5512 7.39371 3.84357 -9.52219 0.418204 -9.11945 -2622 6 44.6779 7.22362 10.1855 -3.82519 12.3682 29.7072 -2623 4 44.5846 7.37997 11.1613 -8.64186 4.71212 -23.3906 -2624 4 45.2067 6.43644 10.1815 9.68596 -14.557 -3.94398 -2625 6 23.537 20.3907 32.2607 -4.33975 0.880185 -5.57314 -2626 4 23.324 21.1985 32.7413 -3.519 5.94106 -1.71472 -2627 4 23.9311 19.8373 32.9365 5.99895 -7.24541 1.02787 -2628 6 37.5412 21.0533 29.2807 6.26587 16.0676 16.0196 -2629 4 37.3761 20.3248 28.6837 -16.0493 -11.7352 -10.5522 -2630 4 36.7218 21.4261 29.6708 7.43039 -8.09007 -9.52559 -2631 6 49.2859 29.0787 28.7031 8.16517 -18.5587 -1.11584 -2632 4 48.658 29.8007 28.598 1.09858 8.52384 -10.5349 -2633 4 50.1522 29.3365 28.3345 -7.12297 8.09394 6.40204 -2634 6 47.5144 18.1684 15.2382 -13.098 45.3115 -50.4885 -2635 4 48.063 17.6794 15.7982 26.613 -22.2712 34.0874 -2636 4 48.011 18.9832 14.9644 -13.0138 -21.3801 10.9042 -2637 6 23.2587 11.168 16.5961 -34.2623 -16.0228 11.9175 -2638 4 23.8181 11.8474 16.2701 22.3391 18.1069 -12.9732 -2639 4 23.6107 10.3074 16.3447 5.63526 2.71733 -4.05723 -2640 6 3.14661 8.32736 23.1966 -5.33081 14.6732 5.33529 -2641 4 3.33443 7.84562 22.3891 5.23826 -4.81966 -4.36628 -2642 4 3.62138 9.17513 23.1245 -2.82501 -4.35917 1.75332 -2643 6 0.508878 16.1819 6.17622 16.4304 7.97407 55.7173 -2644 4 1.47866 16.3831 6.12713 -25.5039 -9.61354 -6.44341 -2645 4 0.329178 16.1408 7.1857 2.48639 -0.0834422 -46.7437 -2646 6 43.1796 15.6993 5.84098 -15.9449 -20.1226 -10.4934 -2647 4 42.9586 16.4507 6.36104 0.864404 19.5468 17.3894 -2648 4 44.0486 15.8407 5.47017 17.9332 8.6581 -2.45416 -2649 6 16.7038 35.4743 34.4518 -23.198 12.4372 32.502 -2650 4 15.9504 35.0582 34.0028 7.47206 -3.63127 2.95791 -2651 4 16.3197 35.7905 35.3305 20.1374 -9.24319 -26.2799 -2652 6 38.8854 7.73874 15.6833 27.6202 35.8952 13.402 -2653 4 39.2486 7.07212 15.1014 0.737034 -8.76325 -8.48971 -2654 4 39.6641 8.33099 15.9666 -32.1226 -27.7665 -11.1551 -2655 6 42.0076 36.5182 13.641 -8.45099 16.164 -4.64077 -2656 4 41.9228 35.5752 13.5656 2.538 -16.9665 4.44933 -2657 4 41.1544 36.8356 13.3036 3.7559 4.14555 2.82714 -2658 6 54.2986 15.3848 32.1119 10.5246 -16.1102 10.831 -2659 4 0.035655 15.9755 32.3754 -8.42237 -3.15332 1.00609 -2660 4 53.5781 15.9253 31.7943 -3.3302 7.96061 -4.64421 -2661 6 22.8954 13.9973 39.0304 35.7671 -1.21675 7.49641 -2662 4 23.2761 14.8055 39.421 -4.93619 -7.73369 -6.00904 -2663 4 21.9819 14.1606 38.8837 -32.0989 6.28079 -4.51925 -2664 6 48.0426 28.53 4.78367 -18.7604 -12.0579 33.007 -2665 4 48.5209 28.7824 4.01456 21.1512 11.8238 -22.7946 -2666 4 47.6247 29.3288 5.14776 5.26678 3.3179 -1.38234 -2667 6 48.833 10.6059 2.66638 -9.19187 -9.9608 -41.9733 -2668 4 48.2371 10.184 3.25557 -19.2293 -15.3999 15.8868 -2669 4 49.4018 11.1117 3.19515 27.1663 25.8201 26.2609 -2670 6 17.1043 29.3494 4.41938 0.116954 -3.05469 4.91749 -2671 4 16.3442 28.823 4.73493 -1.75912 12.177 1.49975 -2672 4 17.4207 29.929 5.14153 -0.429925 -17.6765 -0.899977 -2673 6 27.7901 7.33424 26.577 58.6208 -10.7281 -9.65958 -2674 4 28.6921 6.89516 26.6033 -20.1634 35.8081 4.28732 -2675 4 27.2961 6.54785 26.6418 -36.3357 -24.7905 3.70209 -2676 6 18.0242 22.0537 22.5144 -27.9591 -16.1551 -40.0832 -2677 4 18.4878 21.2118 22.5153 10.7066 -2.42354 6.7168 -2678 4 17.4966 21.98 21.6478 21.0889 16.8172 36.9195 -2679 6 22.144 25.0979 16.6837 -22.767 31.6961 -6.75713 -2680 4 21.8754 25.6012 15.8609 3.46788 -12.1894 37.0641 -2681 4 22.4796 24.2953 16.3382 13.1119 -24.3628 -7.92486 -2682 6 25.5147 28.4379 7.13209 -32.2353 18.5879 42.0502 -2683 4 25.3191 28.6153 8.09624 16.8162 -18.2828 -29.7283 -2684 4 25.4949 29.3399 6.82105 5.5127 9.28731 -21.7507 -2685 6 42.5447 24.7469 23.7482 -26.0567 17.8354 -0.260974 -2686 4 41.659 25.0561 24.0862 27.8337 1.55541 -7.56443 -2687 4 42.5141 23.8045 23.8516 -5.7883 -22.6777 0.706816 -2688 6 6.24511 16.6188 2.47068 -21.6781 9.7655 5.77715 -2689 4 5.36273 16.9874 2.41541 -6.24724 13.8235 -1.18511 -2690 4 6.01398 15.7093 2.58331 16.9883 -26.009 1.35247 -2691 6 47.3719 33.28 1.46148 -3.99946 1.01934 -28.2481 -2692 4 46.9803 34.1218 1.66358 -4.59906 12.9067 -8.65937 -2693 4 47.69 33.0389 2.30921 14.6803 -12.3184 23.7614 -2694 6 1.27616 36.1851 24.8829 8.16993 1.58395 -5.27854 -2695 4 0.639753 36.4584 25.5359 -13.8461 11.829 3.50901 -2696 4 1.57271 35.3754 25.2942 10.46 -9.74103 -2.86729 -2697 6 20.9413 29.0442 16.4303 -37.0385 3.95749 11.2157 -2698 4 21.4069 28.5201 15.8013 19.747 -14.8546 -14.4583 -2699 4 21.4101 29.8248 16.6953 16.4704 9.62387 -0.234111 -2700 6 18.6701 32.5426 14.1399 -11.935 -28.2137 10.094 -2701 4 17.8036 32.9051 14.2078 -15.3524 29.2867 2.90472 -2702 4 18.4356 31.618 14.3552 23.1856 4.50503 -1.59621 -2703 6 15.7338 41.7002 0.007017 -29.1796 -38.8659 -6.04008 -2704 4 15.5134 41.1073 41.1476 16.5192 17.684 16.0218 -2705 4 15.1804 41.3134 0.738607 16.9589 18.7767 -12.0866 -2706 6 20.5358 18.4015 7.20723 -36.4209 10.7746 11.3165 -2707 4 20.1727 18.4996 8.12034 18.5895 1.11111 -8.73102 -2708 4 19.7156 18.4439 6.66948 20.5956 -6.66311 2.45516 -2709 6 35.3359 2.82506 1.61733 -4.03181 47.7257 29.2165 -2710 4 34.9541 3.20961 2.47337 19.1106 -23.159 -34.5889 -2711 4 35.8528 3.61912 1.28524 -9.69035 -30.1723 1.40188 -2712 6 49.0059 19.6751 24.9502 -26.306 10.305 -4.58994 -2713 4 49.8292 19.282 24.7191 18.9727 -16.8119 -2.00329 -2714 4 49.219 20.61 24.9195 -6.54834 1.96917 8.98321 -2715 6 26.0427 7.1974 41.5664 19.1127 -25.9459 -27.3591 -2716 4 26.6886 6.46136 41.6822 -6.92827 19.3426 1.38611 -2717 4 25.5576 7.23966 0.456505 -11.7101 6.8047 33.8929 -2718 6 22.0248 3.60461 29.0185 -16.0846 7.25678 -9.40108 -2719 4 21.194 3.80897 28.5456 14.569 -4.87522 0.502932 -2720 4 22.1959 4.40114 29.525 4.81678 0.210141 7.58007 -2721 6 27.8548 32.5394 20.644 30.2008 -27.0251 30.2495 -2722 4 26.9598 32.7332 20.4747 -36.3343 12.7784 -11.814 -2723 4 28.412 33.1097 20.1287 0.615935 11.6015 -11.5439 -2724 6 8.3956 24.7909 3.45677 41.8783 30.6212 2.1827 -2725 4 8.85983 24.2427 2.83372 10.4085 -11.4169 -11.9204 -2726 4 7.65564 24.3184 3.74512 -41.6031 -24.257 6.19876 -2727 6 30.5856 41.7288 15.6573 18.8319 11.6475 40.5199 -2728 4 29.9513 0.161741 16.3149 8.82373 -8.1621 -4.69308 -2729 4 30.0935 41.6309 14.8822 -24.2072 -8.84927 -42.274 -2730 6 48.0984 5.63232 21.2085 -24.8678 -8.67647 -10.7387 -2731 4 47.6235 6.28714 20.6867 8.63769 7.09972 -0.446275 -2732 4 47.3595 5.05066 21.4474 12.3779 0.983941 9.20385 -2733 6 39.4236 23.163 35.7324 -26.6807 -22.8308 -31.4054 -2734 4 39.8477 23.6904 36.3502 31.9199 30.6139 46.0523 -2735 4 38.8623 22.5516 36.2186 -1.29306 -3.58423 7.04543 -2736 6 51.5883 33.3617 5.78995 -19.5798 -55.0773 -18.3228 -2737 4 51.7861 34.2574 5.89467 9.96767 53.6603 7.25336 -2738 4 51.5145 33.1869 4.82901 1.99858 6.27826 11.2132 -2739 6 40.1205 17.6413 30.7797 3.51386 -32.8888 9.0941 -2740 4 39.6335 18.3955 31.0853 6.47279 10.0891 -2.42254 -2741 4 40.8254 17.9321 30.1952 -5.08805 1.72673 -6.80625 -2742 6 46.4235 9.81086 18.5807 -13.6096 13.2326 25.0066 -2743 4 47.164 10.4099 18.4597 3.17276 -2.49269 -0.272695 -2744 4 46.3941 9.2422 17.832 2.02048 -17.819 -25.0993 -2745 6 15.8844 41.0843 31.9336 24.9021 -3.26155 -16.7898 -2746 4 16.5805 40.7078 31.3592 -9.31569 -10.1627 6.74042 -2747 4 16.1791 0.090931 31.8861 -11.051 9.97246 9.22539 -2748 6 48.5496 25.7276 14.9325 -23.4699 4.48431 -20.1118 -2749 4 49.4421 25.9075 14.7294 36.7388 1.67727 3.80263 -2750 4 48.1707 25.827 14.039 -11.0362 0.596064 15.3478 -2751 6 39.2225 28.9892 36.1575 1.81804 -9.3363 -11.5399 -2752 4 40.0459 29.1043 36.6225 6.32097 13.8964 11.0865 -2753 4 39.5169 28.7877 35.2623 -5.25992 -5.15898 -10.721 -2754 6 37.325 21.0738 14.9394 -7.85324 -20.9229 -64.7065 -2755 4 37.9996 20.7799 14.2865 -1.58038 10.9233 26.036 -2756 4 36.5898 21.2349 14.28 11.1979 5.88457 46.2171 -2757 6 32.4971 22.8607 15.7433 -7.91212 -33.4559 24.7905 -2758 4 31.7632 22.4534 15.25 1.55934 10.0805 -2.32687 -2759 4 32.5592 22.2921 16.5663 4.31702 21.463 -27.4441 -2760 6 18.5773 8.13014 37.5708 2.8796 34.5567 21.0854 -2761 4 19.1021 8.93687 37.8089 1.20854 -19.8484 -10.1251 -2762 4 17.9431 8.09722 38.288 -3.97249 -3.14491 3.87795 -2763 6 46.9308 30.3817 11.0144 7.20248 -9.32119 -46.6603 -2764 4 46.4987 30.7035 10.1833 6.25688 -3.94108 30.979 -2765 4 47.431 29.6318 10.6212 -6.26387 6.19468 23.2459 -2766 6 54.6355 13.051 30.6677 -0.631529 -12.3617 0.377161 -2767 4 54.9401 12.1973 31.0202 -4.70537 6.73717 3.83911 -2768 4 54.6706 13.679 31.4001 -0.542159 7.57402 -2.77471 -2769 6 32.2973 35.1412 27.9506 0.702746 7.41177 51.9011 -2770 4 32.3519 35.6753 28.7977 -4.11304 1.55554 -34.3644 -2771 4 32.0809 34.2722 28.2835 1.42742 -15.3938 2.35714 -2772 6 4.45353 25.396 31.7914 -28.2716 -32.1048 1.32297 -2773 4 5.00928 24.905 32.4172 3.79617 9.45861 3.32159 -2774 4 4.83781 26.2295 31.6234 26.2458 34.1175 0.407684 -2775 6 40.7781 38.1509 21.8521 -13.1408 -33.509 11.5706 -2776 4 40.6716 39.044 22.1698 7.33695 21.0707 -1.24628 -2777 4 41.4481 38.0623 21.1738 10.5508 14.8215 -9.14642 -2778 6 26.6931 9.85845 27.4042 -43.8759 24.145 24.882 -2779 4 26.9952 9.1619 26.8761 23.7363 -35.7414 -23.7206 -2780 4 25.7673 9.60487 27.6152 14.5566 8.07269 5.62533 -2781 6 53.3967 39.4485 11.7649 68.843 -10.0355 -14.0333 -2782 4 54.4148 39.3855 11.5456 -53.2103 8.20916 12.7106 -2783 4 53.105 40.2482 11.2866 -1.29569 -7.05369 14.3337 -2784 6 35.3292 21.4155 2.23587 15.106 -7.83484 -18.4876 -2785 4 34.912 20.5764 2.48744 -1.27765 6.93695 -0.309601 -2786 4 35.8084 21.2289 1.37944 -21.1629 3.53466 26.6292 -2787 6 4.14409 17.1449 33.9131 -16.1644 -22.9901 22.0601 -2788 4 4.14131 16.4411 34.6063 8.69636 10.7601 -14.4963 -2789 4 3.20404 17.192 33.6728 6.06844 1.20479 -9.99864 -2790 6 24.1486 16.1886 14.6752 2.90394 -28.6462 -21.9437 -2791 4 24.2343 17.059 15.0346 0.494679 15.8947 1.83084 -2792 4 23.7735 16.3203 13.7888 -2.47926 -0.947779 4.85435 -2793 6 43.1303 2.83022 26.0988 7.42094 18.4339 -15.1049 -2794 4 42.3152 3.21229 26.4285 -6.54764 -1.84254 4.96768 -2795 4 43.2129 3.23454 25.2082 4.91034 -11.1878 11.8147 -2796 6 40.68 12.1827 1.56051 12.2683 5.96873 16.2718 -2797 4 41.5968 12.2158 1.84207 12.0551 -6.37233 -9.83141 -2798 4 40.2741 12.5174 2.36876 -21.9125 -2.35909 -10.0625 -2799 6 47.3781 8.09655 26.7608 82.0606 26.064 -7.54845 -2800 4 46.666 7.67998 26.3919 -67.6244 -33.3987 -26.4118 -2801 4 48.0445 8.01522 26.0221 -12.6559 5.80771 33.8866 -2802 6 35.8947 30.7223 38.5098 17.2216 52.6179 -38.6143 -2803 4 35.6523 29.9703 39.0072 10.7188 -28.2359 27.6772 -2804 4 36.8587 31.0199 38.5623 -37.3038 -25.1724 3.03639 -2805 6 51.3054 23.2176 32.4969 -40.2617 11.1267 -4.72183 -2806 4 51.571 23.9803 31.9692 8.10126 9.10595 3.65824 -2807 4 52.0738 22.7076 32.6523 27.5758 -14.8312 4.00399 -2808 6 30.6066 4.44965 39.6625 0.615077 -4.04577 -5.4494 -2809 4 30.9728 3.64581 40.0124 3.38991 -22.1323 -0.234101 -2810 4 30.7691 5.02119 40.3987 0.467535 29.3806 6.08815 -2811 6 35.2584 29.6988 2.86074 -18.8762 -20.4699 -30.2285 -2812 4 35.7444 29.7805 2.00551 -3.31399 -2.84145 17.507 -2813 4 34.478 29.0852 2.62897 29.9452 30.586 13.9144 -2814 6 50.3064 26.1399 9.38994 -11.2342 14.6262 -3.47403 -2815 4 49.9288 26.8854 8.86032 11.0364 -25.2497 6.23881 -2816 4 49.6695 25.4035 9.37359 7.94529 9.32604 -3.86417 -2817 6 50.1026 36.8163 26.4125 -14.5138 -5.51826 -11.285 -2818 4 49.5888 36.0167 26.6617 3.79204 13.187 5.56915 -2819 4 50.2319 37.3727 27.1922 -3.20057 1.11223 6.19844 -2820 6 40.3045 23.9511 38.5442 56.3682 27.7758 -3.16545 -2821 4 40.8125 24.7624 38.7991 -6.5383 -29.3065 -12.768 -2822 4 39.4568 24.2221 38.8139 -44.6373 -1.162 12.0349 -2823 6 24.9504 10.7612 30.6561 23.3702 -4.90777 36.4738 -2824 4 25.6234 10.7245 31.4083 -25.7901 9.07318 -40.0098 -2825 4 24.9126 11.6687 30.2959 1.4184 -10.5997 2.42613 -2826 6 5.89627 1.02238 5.41014 -10.9637 -3.10309 -8.95081 -2827 4 5.14436 0.409378 5.47088 11.7326 -0.810065 6.31118 -2828 4 6.70289 0.529043 5.60145 -0.696658 -1.4992 -0.407558 -2829 6 44.282 29.3718 26.2736 69.4655 -24.0165 25.5627 -2830 4 43.5561 29.7046 25.8233 -49.9183 11.7173 -34.3685 -2831 4 44.8903 28.8623 25.6892 -19.9675 5.54095 9.74148 -2832 6 25.3119 10.1784 6.67292 -15.7736 -23.3412 -3.06725 -2833 4 25.6521 11.0537 6.64576 10.6351 24.7362 -4.37451 -2834 4 25.4625 9.79379 5.79618 6.21987 0.326131 1.26241 -2835 6 13.3514 28.0662 2.56722 45.2358 13.6418 17.9819 -2836 4 12.4545 27.8107 2.56105 -32.9681 -11.4511 -11.8173 -2837 4 13.8041 27.7134 1.79344 -6.10921 -0.687749 -0.120894 -2838 6 6.44709 40.2351 18.0254 21.2427 9.30891 -1.39987 -2839 4 6.966 39.4726 17.7533 0.137807 -7.29984 6.20872 -2840 4 5.59682 40.0602 17.6456 -22.1821 0.316247 -4.7234 -2841 6 47.7944 13.5061 2.01255 -17.6425 -30.8617 30.605 -2842 4 48.2016 12.6358 2.19438 -7.04124 7.54818 -3.24284 -2843 4 48.4122 13.9735 1.50015 28.8905 20.8749 -24.4455 -2844 6 13.5944 20.2974 2.4458 20.0315 11.2691 18.6487 -2845 4 13.7883 19.6075 3.10831 1.39134 9.87367 -8.40212 -2846 4 13.0064 19.8713 1.85297 -21.5499 -10.3053 -19.2062 -2847 6 15.2336 0.850818 36.6661 8.37652 40.6516 -23.9146 -2848 4 15.3117 1.46746 37.4264 -6.40063 -24.0213 -7.24367 -2849 4 15.3514 1.51981 35.909 -6.71396 -40.605 26.1829 -2850 6 33.5971 35.2491 15.0847 71.6425 -10.6997 11.4711 -2851 4 33.8969 35.3297 16.0058 -20.0956 -0.49545 -2.4869 -2852 4 34.508 35.0431 14.6807 -47.978 4.31732 -2.67502 -2853 6 21.7981 9.23698 0.429299 24.0185 -25.5324 29.6504 -2854 4 22.426 9.07175 41.6424 8.6426 -4.20457 -11.04 -2855 4 21.1884 9.81045 0.032847 -35.1273 25.1593 -17.3244 -2856 6 38.1453 27.4709 3.0333 47.9463 -55.6761 10.6859 -2857 4 37.7532 27.3037 2.19157 -17.0599 1.14667 -24.2168 -2858 4 37.8405 28.2288 3.44687 -27.291 50.0057 16.1216 -2859 6 38.8714 27.215 11.7709 41.141 -36.7506 -15.3879 -2860 4 38.9285 26.3434 12.2193 -14.3396 10.7389 0.963039 -2861 4 39.5886 27.0941 11.0922 -22.6073 11.6268 16.0227 -2862 6 29.8734 41.5737 28.6987 15.2279 35.2113 -10.5566 -2863 4 28.9552 41.3162 28.7047 -13.1778 -5.77603 2.88395 -2864 4 29.9141 0.263017 27.9132 -0.896253 -12.9147 16.3719 -2865 6 34.03 8.70777 38.0687 38.5763 27.6628 16.1728 -2866 4 34.8607 8.18924 38.1985 -14.88 11.0383 -8.6682 -2867 4 33.3419 8.15213 37.7593 -24.3719 -27.4308 -8.08559 -2868 6 38.8091 27.3495 30.6738 6.32435 -21.1782 -4.52762 -2869 4 38.5154 26.4386 30.4378 -1.34454 21.7952 1.35616 -2870 4 38.3686 27.5808 31.4849 -11.9448 1.82739 7.69603 -2871 6 41.6473 17.269 36.3639 7.45605 15.5752 1.52238 -2872 4 41.3137 17.162 35.483 -10.4634 0.342165 -15.0979 -2873 4 41.7169 16.3923 36.7151 5.72978 -18.5967 8.16978 -2874 6 30.7243 26.977 35.2074 -15.5404 -28.2563 -3.1326 -2875 4 31.3953 27.4345 34.7177 18.5093 15.4635 -5.31058 -2876 4 30.2206 27.5565 35.766 -0.690558 20.2492 9.56945 -2877 6 47.5414 4.09198 27.2867 -2.42911 13.6608 18.2544 -2878 4 46.636 4.37242 27.4325 -10.4037 -2.52064 9.15115 -2879 4 47.5606 3.99786 26.3497 6.55325 -3.96267 -23.0579 -2880 6 20.946 8.39203 7.27322 -27.8597 -45.7319 -0.818331 -2881 4 20.9365 8.74812 8.15774 -0.207227 20.4039 13.5637 -2882 4 21.4094 8.93893 6.67191 21.7448 31.5979 -18.7028 -2883 6 36.8544 13.691 0.855516 -6.96494 -6.58957 -4.7536 -2884 4 37.3845 13.474 1.605 15.5913 2.53244 29.7992 -2885 4 37.0002 12.9032 0.328977 -4.78774 -2.28905 -12.5933 -2886 6 28.5904 20.2994 26.4544 16.2695 -3.42806 -15.5352 -2887 4 28.4835 19.402 26.1318 -1.12761 -3.3858 2.90642 -2888 4 27.7814 20.5406 26.8733 -22.93 6.76513 15.2817 -2889 6 51.6079 16.8571 33.5121 -4.50033 -4.43314 5.93611 -2890 4 51.6159 16.0837 34.101 -3.91985 -0.958274 -7.09147 -2891 4 50.9053 16.6875 32.8669 7.1497 -2.58651 -2.16023 -2892 6 16.2715 32.0073 37.6936 -41.8913 -21.032 -18.7972 -2893 4 16.4093 31.405 38.4555 0.0363557 12.0183 -19.687 -2894 4 15.4977 31.6058 37.1477 38.3353 16.8511 22.6146 -2895 6 14.3407 25.877 13.2155 1.26588 11.3619 -17.2713 -2896 4 13.5013 26.0279 13.6901 5.40221 7.27027 -0.947788 -2897 4 14.4551 26.5608 12.5093 -9.57117 -0.277473 20.5459 -2898 6 54.9749 28.8768 3.30374 1.15612 -53.5629 -1.59986 -2899 4 54.8083 28.9028 2.3467 2.04661 0.129141 5.0455 -2900 4 0.26744 27.9124 3.48546 -12.4506 41.1861 -2.95604 -2901 6 17.22 5.15598 2.57931 -12.7888 -35.846 -9.7104 -2902 4 17.8674 4.52191 2.91459 -1.87097 -9.90488 -4.08214 -2903 4 17.421 5.9071 3.09191 1.36943 25.6696 10.0797 -2904 6 50.6995 33.0507 10.3154 6.59719 15.9916 42.5002 -2905 4 50.6222 33.8517 9.79386 -1.28667 2.08485 -11.8542 -2906 4 50.7575 32.2667 9.79209 -3.80283 -15.7636 -22.9095 -2907 6 28.8826 19.8405 32.3742 18.5732 17.2051 -15.397 -2908 4 29.8373 20.0763 32.2 -31.4986 -11.6613 7.66973 -2909 4 28.4094 20.6578 32.1253 1.55933 -8.77069 7.582 -2910 6 22.4307 12.8248 23.2991 -20.6917 10.5217 33.6658 -2911 4 22.5556 12.3422 24.1574 -2.40655 13.6672 -16.3005 -2912 4 21.7108 13.488 23.4947 18.3613 -16.8762 -11.246 -2913 6 54.7763 15.5394 8.86893 2.10476 3.1215 13.1486 -2914 4 0.465115 15.309 9.51431 10.762 -2.70861 -3.02895 -2915 4 53.9989 15.1653 9.30174 -3.31272 -0.629746 -12.248 -2916 6 10.4518 19.2967 26.1704 43.67 -11.1159 60.7251 -2917 4 11.2502 18.7163 26.2348 -22.5321 13.8961 -6.48776 -2918 4 10.166 19.2541 25.3007 -24.1973 -3.18459 -58.4054 -2919 6 38.6496 20.2998 35.2325 20.2193 -0.813999 -8.63065 -2920 4 39.5955 20.3672 34.9603 -17.6326 -1.16496 9.70871 -2921 4 38.5782 19.6093 35.9099 2.97533 6.68842 -2.65526 -2922 6 17.4906 18.0487 15.2499 -10.3405 45.0299 20.0184 -2923 4 17.3837 17.5615 14.4531 -8.22833 -15.0257 -32.2828 -2924 4 17.2318 18.9864 14.9797 13.5676 -28.3997 10.204 -2925 6 29.6331 0.960567 26.2796 -25.6031 -26.3316 -72.4206 -2926 4 29.3216 1.74647 25.7973 3.40072 6.61544 23.4347 -2927 4 29.2407 0.266373 25.6265 23.6279 16.4272 47.4057 -2928 6 30.4665 12.6849 28.2971 -10.7965 -27.9245 1.17671 -2929 4 29.8272 13.0822 27.7097 -1.40549 16.7134 -9.61387 -2930 4 30.1324 11.7665 28.3519 9.60572 9.94425 5.65357 -2931 6 36.6695 22.1225 33.3577 39.6017 -11.6369 -25.7224 -2932 4 37.5338 21.6663 33.4931 -10.4393 24.3252 -8.31461 -2933 4 36.1732 21.6976 34.0074 -34.1256 -9.27026 38.9845 -2934 6 34.8672 22.4666 14.3113 -12.0535 -16.0605 -66.2467 -2935 4 34.0349 22.4515 14.7407 -19.1997 11.5289 38.0952 -2936 4 34.5417 22.174 13.4128 25.6484 2.69091 24.3313 -2937 6 15.5262 9.60919 7.44527 49.3682 -27.3699 -19.0187 -2938 4 16.547 9.52246 7.26069 -54.7763 6.57045 5.33777 -2939 4 15.1277 8.71762 7.26288 7.76902 16.5773 17.8238 -2940 6 21.8158 28.0339 19.8054 -4.91607 2.79332 -16.2053 -2941 4 21.8614 28.4614 20.6522 -2.04715 7.82991 15.4338 -2942 4 20.8734 27.9328 19.6183 -0.9528 -10.4666 6.26348 -2943 6 34.5348 24.4247 2.43569 30.4222 -68.2311 14.7367 -2944 4 34.4753 23.4054 2.32054 1.69344 45.6403 0.121788 -2945 4 35.3397 24.4934 3.03523 -29.9154 15.8849 -16.545 -2946 6 12.599 20.9348 33.4989 -13.8827 -5.0407 19.8786 -2947 4 11.7591 20.6911 33.9854 14.8004 1.51093 -27.4282 -2948 4 12.4712 20.9089 32.5331 -6.4324 -2.96843 13.903 -2949 6 45.7737 31.1538 8.70434 -2.26925 11.3362 1.64289 -2950 4 45.9542 32.0869 8.96415 -8.39554 -11.7705 -15.6468 -2951 4 44.8313 30.9442 8.82297 5.93432 7.3758 2.64979 -2952 6 15.4817 22.5529 30.1787 5.69125 -30.6905 2.54506 -2953 4 16.2669 22.9885 30.4865 5.73919 23.8488 1.47991 -2954 4 15.7828 21.6299 30.2043 -15.5749 7.04719 -4.74998 -2955 6 39.7421 17.1743 38.4094 21.5551 17.0277 -9.47446 -2956 4 39.5031 16.7163 37.59 -3.21419 -6.16335 13.1695 -2957 4 40.5012 17.7258 38.123 -12.3818 -10.233 9.13463 -2958 6 13.9944 24.6739 0.675362 16.6213 17.4065 1.77653 -2959 4 14.3534 24.6315 1.57006 -7.52322 -5.04497 4.60086 -2960 4 14.2363 25.5684 0.403337 7.11699 -3.23043 -4.31609 -2961 6 31.5223 19.5616 3.57151 -53.5885 6.24325 20.3398 -2962 4 30.9852 19.2876 4.35912 8.49606 10.2921 -25.2864 -2963 4 32.3806 19.3906 3.88708 44.0272 -8.41539 -5.41474 -2964 6 36.1052 25.07 19.4414 -58.1964 5.4792 30.944 -2965 4 37.0178 24.9674 19.4291 53.7837 8.57858 1.17104 -2966 4 35.8724 24.6048 18.6565 -11.4284 -6.26335 -25.0938 -2967 6 51.6856 17.6883 14.8068 3.37141 18.4291 36.2611 -2968 4 51.7159 18.5692 15.274 12.631 -26.1695 -13.2311 -2969 4 51.0805 17.8845 14.1157 -15.036 4.32684 -29.7308 -2970 6 37.7054 27.4905 38.1961 21.1085 51.9404 -4.50496 -2971 4 37.7442 26.8536 37.5026 -5.7586 -24.9449 -15.2301 -2972 4 38.1753 28.2651 37.7886 -14.569 -23.1779 14.5181 -2973 6 34.7911 13.8542 30.7834 63.814 8.34946 -38.9004 -2974 4 35.1479 14.6416 31.2053 -8.52888 3.60926 11.6955 -2975 4 33.9958 13.5796 31.1473 -54.5977 -12.3598 32.1143 -2976 6 19.6332 37.3754 39.9698 -24.3625 -2.8653 -8.02349 -2977 4 20.5737 37.5051 40.1221 10.6449 -2.37562 -1.97502 -2978 4 19.476 36.9037 39.1231 9.83703 4.21653 7.37417 -2979 6 40.9393 34.0697 21.4586 2.1394 -11.0927 -27.2527 -2980 4 41.1855 34.0244 22.3739 -0.995015 -5.02364 12.6588 -2981 4 40.8269 33.1391 21.1809 -5.56645 12.5591 1.05516 -2982 6 32.9542 27.2131 26.5676 21.8236 31.3611 42.3808 -2983 4 33.7455 27.7378 26.9411 -38.3522 -19.3744 -9.62352 -2984 4 33.2804 26.8388 25.7801 14.7034 -8.88898 -37.5519 -2985 6 24.4045 18.6625 15.6046 15.6323 5.3487 0.0952382 -2986 4 23.6496 19.2317 15.7207 -14.8084 -1.4602 1.41466 -2987 4 24.5649 18.2576 16.462 -0.219489 -3.50303 9.55317 -2988 6 29.9663 1.63299 9.06934 -19.1782 58.0281 -13.4952 -2989 4 30.0652 0.728361 9.20589 6.15764 -53.3299 8.23098 -2990 4 29.142 1.69178 8.53744 13.8409 -0.846673 8.85197 -2991 6 31.4884 20.0987 7.87879 28.0207 -11.7442 -56.0977 -2992 4 31.929 19.6692 7.07379 -7.62771 20.3934 38.6055 -2993 4 30.8102 19.4535 8.0257 -16.4635 -8.90407 20.6678 -2994 6 35.0404 3.79156 33.2694 -1.07326 -4.91424 22.8916 -2995 4 34.2545 4.23611 32.9039 10.815 -2.65177 -4.17514 -2996 4 34.969 3.91026 34.2418 -2.62674 -1.77539 -18.1187 -2997 6 43.9504 7.96546 12.9857 17.1829 -21.9111 0.113786 -2998 4 43.3325 7.29581 13.3448 8.44862 12.3123 -3.96012 -2999 4 43.4563 8.73573 12.7333 -15.1408 11.4953 0.0339333 -3000 6 44.1156 32.6759 16.9403 5.31814 23.9263 4.94933 -3001 4 44.7028 33.4557 16.8081 -6.11209 -18.3833 -3.28173 -3002 4 44.1603 32.5425 17.8901 -3.26507 -3.06823 6.73624 -3003 6 40.6044 27.171 19.0399 5.35236 -7.54795 -39.8413 -3004 4 39.9756 26.4797 18.7399 3.73803 11.5815 8.49028 -3005 4 41.0398 27.5246 18.2027 -12.4172 -8.32437 32.3474 -3006 6 46.047 23.2024 29.047 17.2683 37.2743 26.3298 -3007 4 46.6657 23.8797 29.4684 -18.5589 -27.346 -17.4569 -3008 4 46.486 22.3548 28.9238 8.34839 -6.65718 2.80441 -3009 6 42.6215 30.6103 18.862 -5.01232 -15.325 -26.4249 -3010 4 43.5272 30.7476 19.0895 18.324 11.0008 12.4889 -3011 4 42.704 29.9429 18.1625 -17.0641 3.12823 2.85026 -3012 6 36.1251 10.8932 23.2678 23.6581 36.1082 4.04534 -3013 4 35.2523 11.2865 23.1129 -2.80799 -1.69562 1.02392 -3014 4 36.6983 11.6913 23.4963 -28.2294 -33.6871 -7.78786 -3015 6 13.7386 31.5223 15.7271 -4.49361 3.73805 -16.8081 -3016 4 14.6779 31.7192 15.7387 3.94655 -1.56597 5.72926 -3017 4 13.381 32.0318 14.979 -1.5565 -4.12563 8.0657 -3018 6 33.1703 41.4275 27.7797 10.5813 -15.702 68.4674 -3019 4 32.9714 0.101499 27.0951 -7.66273 31.9341 -41.1766 -3020 4 33.2579 0.043937 28.6255 4.60937 -17.5422 -27.6682 -3021 6 32.9019 22.9042 31.4856 -22.5274 37.748 -5.90861 -3022 4 32.2895 23.1741 30.7829 6.44322 -22.1433 -13.1277 -3023 4 32.7242 23.6662 32.0583 13.0029 -8.58894 11.8377 -3024 6 27.6559 16.8629 6.38841 0.759442 -6.33883 29.8789 -3025 4 27.8611 17.2083 5.54221 8.69809 17.4791 -25.8043 -3026 4 26.8031 16.4594 6.24591 -13.957 -6.38022 2.63501 -3027 6 47.2651 11.6173 26.0576 8.33461 35.0159 47.6166 -3028 4 47.0912 11.6838 27.0214 -5.10661 -22.4254 -22.6877 -3029 4 47.7461 12.4597 25.9756 -3.10554 -9.06377 -24.8427 -3030 6 27.5595 7.06242 7.64189 36.0057 -29.1625 5.70238 -3031 4 26.7484 7.49683 7.83093 -25.0876 11.7282 17.2448 -3032 4 28.0841 6.86482 8.45622 -15.7481 15.6684 -17.1357 -3033 6 39.8009 9.06823 11.973 -19.1879 4.0297 -12.8881 -3034 4 39.4826 9.27056 11.0665 6.39012 -4.37616 15.6201 -3035 4 38.9894 9.1094 12.5089 2.28999 7.64442 -1.09803 -3036 6 18.1977 33.4656 36.103 -47.2434 1.22325 7.58723 -3037 4 17.6693 33.9565 35.4324 13.0563 -6.22307 9.58411 -3038 4 17.491 33.069 36.7104 31.5801 5.82297 -20.8408 -3039 6 37.1917 26.5507 0.720984 -4.45309 15.6177 5.32368 -3040 4 37.3846 25.6567 0.44907 -1.85313 -8.64798 -1.56679 -3041 4 36.2207 26.6114 0.739208 8.96605 -1.46339 -9.13916 -3042 6 44.1887 19.6251 36.8885 40.0452 -6.58607 -3.19327 -3043 4 45.0262 19.1233 36.6753 -25.2412 9.90919 11.1214 -3044 4 44.4881 20.5478 36.9825 -7.95545 -4.32402 -1.12283 -3045 6 27.7744 6.35339 35.6933 13.1235 -8.00403 1.40836 -3046 4 27.1655 6.97567 35.3121 -8.4989 9.93248 -6.95364 -3047 4 27.2748 5.53908 35.7675 0.865215 -2.72076 5.22838 -3048 6 34.7673 16.4826 20.8897 25.0208 -26.1622 5.09639 -3049 4 35.5801 15.8751 20.9364 -40.3091 28.8833 0.638889 -3050 4 34.1629 16.1653 21.5964 8.34467 8.45669 -12.6288 -3051 6 39.0349 20.9701 40.4369 -35.0548 -83.2732 -20.3586 -3052 4 38.7355 20.0763 40.8679 21.616 52.9309 -20.1646 -3053 4 39.3277 21.5521 41.0958 10.956 28.6509 41.127 -3054 6 10.8075 27.9275 1.66251 45.0798 11.5101 -39.3642 -3055 4 10.1207 27.6506 2.20454 -46.3214 -11.9312 37.0665 -3056 4 10.864 28.8887 1.77269 -0.956148 -2.75571 -0.87801 -3057 6 47.0235 23.1304 13.2457 -34.1648 -14.46 -9.62139 -3058 4 47.6809 23.5773 12.718 7.19949 7.22116 -4.18429 -3059 4 46.2703 22.9258 12.6132 27.3011 3.73645 28.26 -3060 6 34.5862 28.4037 10.6629 -11.4192 -4.75939 1.42695 -3061 4 34.4799 27.7252 11.3319 -5.35328 -3.69815 4.40234 -3062 4 35.5403 28.4214 10.6073 9.29856 11.2923 -14.2157 -3063 6 3.3474 17.5828 14.2796 -19.4871 24.8451 -12.2706 -3064 4 3.54237 16.6973 14.5399 7.15819 -24.2504 13.4427 -3065 4 3.84281 18.1577 14.8755 9.98901 -5.90389 -1.38432 -3066 6 27.7213 11.5993 7.52196 5.39723 39.0715 -5.17771 -3067 4 27.6701 12.604 7.61024 4.43832 -37.6789 -1.1729 -3068 4 27.2296 11.2227 8.25132 -2.72363 -3.1191 8.53492 -3069 6 41.4314 28.3382 9.01837 19.0589 -0.973961 -18.7609 -3070 4 40.8555 28.7961 9.62238 -6.75468 20.1798 6.66135 -3071 4 41.7073 28.957 8.28743 -10.8025 -14.2077 17.7393 -3072 6 42.0854 4.7797 8.18851 -21.257 14.5957 -52.3899 -3073 4 42.0432 5.70949 7.81908 14.9695 -22.9802 20.9203 -3074 4 41.8649 4.22501 7.38905 12.6142 12.8494 32.4876 -3075 6 28.4682 8.6325 40.3242 -61.7219 6.47809 -5.55454 -3076 4 27.7379 8.57122 40.9835 27.869 -4.13123 -2.00049 -3077 4 27.8882 8.69791 39.5144 34.8971 -1.31486 9.68376 -3078 6 0.711352 18.2475 15.2828 -1.03732 14.0577 26.4962 -3079 4 1.6037 18.2498 14.9622 18.0256 -6.96047 -13.9963 -3080 4 0.201613 17.7329 14.6701 -10.6254 -13.4061 -11.9404 -3081 6 7.11345 16.2289 40.4432 8.45023 -35.9074 47.1296 -3082 4 7.17312 15.3057 40.7986 -0.221024 11.0765 -27.8146 -3083 4 7.22051 16.6703 41.3088 -5.23596 22.4775 -22.5048 -3084 6 41.0858 8.62552 20.9048 11.0684 -11.3616 26.0286 -3085 4 40.3918 8.42716 20.2762 -10.0062 9.73992 -12.3328 -3086 4 41.3944 9.53753 20.8124 -4.81268 6.06535 -10.7329 -3087 6 31.7073 7.42286 37.542 -14.8479 -9.90339 6.69006 -3088 4 31.4959 7.12404 36.6506 2.47263 0.526998 -6.01676 -3089 4 30.9335 7.11441 38.0458 14.4773 7.59586 -0.291785 -3090 6 40.7266 11.6476 25.425 -35.4896 13.4329 -16.1803 -3091 4 40.7395 12.5913 25.6925 9.9362 -18.5419 -7.18222 -3092 4 41.5423 11.2236 25.6435 22.7694 -4.71413 12.394 -3093 6 29.8665 30.1579 6.66307 26.6562 -4.16721 8.5177 -3094 4 30.5555 30.7343 6.31583 -2.18777 1.73834 -10.5199 -3095 4 30.3573 29.3259 6.76714 -13.2281 -1.59651 -6.45815 -3096 6 40.8439 24.5837 5.68012 15.8615 33.1962 -4.14396 -3097 4 41.3457 25.4223 5.9023 -8.27611 -29.5734 -8.52614 -3098 4 40.1119 24.5659 6.27901 -12.3156 -1.80355 11.8721 -3099 6 34.3917 9.09675 20.4219 17.6262 -1.15942 17.9162 -3100 4 33.57 9.43601 20.7884 -5.86563 4.88571 -3.34935 -3101 4 34.2167 8.80099 19.5352 -13.2656 -6.03918 -15.2606 -3102 6 18.2311 33.5548 26.5354 9.60899 -55.578 -54.4315 -3103 4 19.159 33.2107 26.4405 -23.3884 24.4218 8.45675 -3104 4 18.1621 34.044 27.3085 3.33799 34.4716 53.9641 -3105 6 28.9072 17.4193 26.7965 8.90265 -1.34032 10.3526 -3106 4 28.3267 16.8801 26.2506 -9.53448 5.67773 -5.57268 -3107 4 28.3756 17.7646 27.5432 9.63981 -8.23286 -8.72686 -3108 6 50.4255 35.5446 18.192 14.112 9.6817 -2.74072 -3109 4 50.5661 35.3326 17.2487 -8.6314 -7.47676 15.7559 -3110 4 50.5766 34.7477 18.7329 -11.9848 3.75846 -10.2286 -3111 6 2.99463 21.5653 31.4474 1.68271 -21.0005 -22.757 -3112 4 3.33698 22.262 30.8385 -11.1525 -11.1618 12.076 -3113 4 2.83901 20.7479 30.8788 5.9339 29.1288 19.4027 -3114 6 36.1811 18.7457 8.60665 26.0746 50.7707 2.54435 -3115 4 36.1969 17.9289 9.04749 -6.79937 -48.2248 12.3681 -3116 4 35.6147 18.7828 7.85483 -18.853 -7.00319 -22.0811 -3117 6 20.2934 6.48366 33.7248 -33.7925 -21.1439 9.08779 -3118 4 19.8228 6.33509 34.5702 11.9648 11.0481 1.53323 -3119 4 19.9109 5.73333 33.234 17.8653 6.32962 -8.93867 -3120 6 14.0016 30.5326 6.65439 -2.06342 0.226434 14.1624 -3121 4 14.6658 31.0189 7.18657 -8.4774 -5.82658 -13.2159 -3122 4 13.1556 30.6664 7.11082 5.19683 1.19435 -6.65694 -3123 6 36.2738 16.4523 35.7634 28.7444 28.7466 -1.25628 -3124 4 37.2529 16.3082 35.8444 -30.8138 -2.80693 3.80535 -3125 4 36.1869 17.4417 35.6433 -1.25715 -33.4762 0.326736 -3126 6 45.8255 37.6646 9.68707 16.0609 -41.2042 -13.6418 -3127 4 45.4852 38.2919 10.2717 -20.4348 34.8513 25.7777 -3128 4 46.231 37.0083 10.2774 7.06244 2.74597 -12.4723 -3129 6 47.4229 17.9968 27.6368 -1.79372 -57.0164 -4.60636 -3130 4 47.566 17.432 26.8065 -4.8869 24.4286 27.8294 -3131 4 47.3631 17.3546 28.4089 6.87022 22.2846 -25.0829 -3132 6 25.9574 18.2976 0.964228 23.0858 -4.77958 -10.3735 -3133 4 26.3734 18.9022 1.60725 -19.9671 -4.02324 -2.33442 -3134 4 24.9961 18.2982 0.948557 -9.32218 6.60301 10.8105 -3135 6 27.3657 22.4026 4.28337 1.04907 -15.9856 -17.2206 -3136 4 27.2658 23.3197 4.47064 2.83879 26.7243 10.1579 -3137 4 27.3462 22.4079 3.3181 -1.05974 -10.8362 7.50108 -3138 6 3.39902 3.84297 27.6033 -32.797 -16.937 8.3321 -3139 4 3.87422 4.64571 27.4715 26.6916 15.5682 -1.1402 -3140 4 3.96055 3.06079 27.6076 7.92228 2.5358 -5.38712 -3141 6 45.3564 27.6573 28.835 13.8657 -6.64535 19.4164 -3142 4 44.592 27.1099 28.6295 -10.1072 2.65107 -0.516215 -3143 4 45.3903 28.3299 28.161 -2.22034 5.33578 -9.67936 -3144 6 28.3928 32.384 16.2149 35.1766 -7.36337 1.61596 -3145 4 29.2284 32.2059 15.7054 -23.0821 5.0916 11.0276 -3146 4 28.7076 32.6186 17.1078 -8.03404 1.42552 -9.59962 -3147 6 9.90485 33.8293 13.0286 10.5996 -3.42126 36.647 -3148 4 9.63365 33.2371 13.7754 2.50037 15.8816 -14.8106 -3149 4 9.32864 33.6931 12.2897 -16.1444 -6.90665 -19.0975 -3150 6 38.3335 26.6343 14.9205 -0.551684 -24.4487 3.86314 -3151 4 38.658 25.7334 15.149 1.53578 20.736 -5.06851 -3152 4 37.3858 26.5974 15.0972 1.00556 4.30146 -0.183996 -3153 6 31.3571 16.3836 4.2445 -16.7299 -18.7641 16.8138 -3154 4 30.5501 15.9079 4.56795 14.9054 8.61271 -6.80276 -3155 4 31.2311 16.4593 3.29715 -1.72501 9.16645 -9.12782 -3156 6 6.17482 3.39637 6.55833 17.6941 29.4886 56.031 -3157 4 6.41103 3.08651 7.49149 -7.06328 10.7723 -41.2395 -3158 4 5.9143 2.63963 6.07247 -2.51266 -29.5732 -15.1374 -3159 6 42.5954 13 5.61529 2.6815 -10.2341 6.00586 -3160 4 42.2228 13.83 5.89445 -1.70762 9.74234 -1.3058 -3161 4 43.4476 12.9425 6.06763 3.18432 -3.38396 -9.63491 -3162 6 41.0469 31.4032 33.8032 -2.41258 31.7421 -2.74763 -3163 4 40.7074 31.3974 34.7214 7.44932 1.1292 -16.4995 -3164 4 41.1575 32.3688 33.5162 -1.31614 -41.8694 16.6901 -3165 6 52.8576 12.0626 26.2641 9.5895 -24.4248 -55.9842 -3166 4 52.4684 12.727 26.7939 -19.7064 26.0739 18.5009 -3167 4 52.6066 12.2568 25.3043 12.3637 -4.77707 33.6793 -3168 6 39.2086 4.29542 29.0724 8.4008 5.1904 -7.5125 -3169 4 38.4444 4.85752 29.2861 11.0986 -5.7068 1.32154 -3170 4 39.9986 4.64958 29.5231 -9.05665 -5.78587 -2.57989 -3171 6 3.65769 27.0104 11.285 -33.2394 -3.70913 -3.8751 -3172 4 4.59992 26.8829 11.3514 17.6792 2.33561 -5.11125 -3173 4 3.4519 27.7953 10.7423 10.2361 0.60791 3.91121 -3174 6 41.5441 29.6402 25.2654 2.79284 -4.6021 22.0238 -3175 4 41.8464 29.7038 24.3667 4.04268 2.71218 -16.2057 -3176 4 40.7127 30.1073 25.3399 -6.11251 5.69311 -9.79107 -3177 6 50.4754 27.4974 30.671 -6.87832 -12.1873 7.27551 -3178 4 50.0778 27.1279 31.4799 3.22248 2.82006 -4.01445 -3179 4 49.7824 27.9982 30.2275 0.0461655 4.73 -3.38362 -3180 6 32.7876 33.6322 41.7537 -8.7541 -8.89692 -39.0089 -3181 4 33.1671 32.7559 41.8028 5.47994 -11.5785 5.15438 -3182 4 32.9083 34.029 0.675063 4.83491 15.974 33.6037 -3183 6 5.9806 9.64323 7.93715 4.3965 6.41539 -15.2951 -3184 4 5.77829 9.93579 8.8312 0.6559 3.73469 4.68299 -3185 4 6.3228 10.4083 7.4265 1.56495 -8.59939 9.02132 -3186 6 52.7884 25.3949 27.7 -7.43266 -9.74322 -1.44878 -3187 4 52.93 26.351 27.8747 -0.851616 -24.8244 8.41831 -3188 4 52.9998 24.8518 28.4994 7.3809 16.2458 -18.9874 -3189 6 18.6796 23.2043 14.4609 8.49541 46.7244 28.1607 -3190 4 18.697 24.1166 14.872 -21.1178 -26.825 -16.729 -3191 4 19.5981 23.1771 14.2416 15.365 -21.3066 -15.3625 -3192 6 31.2857 9.07887 13.0786 26.2489 -54.2202 -11.3888 -3193 4 31.3193 8.20519 13.5416 -2.63874 16.5358 -10.154 -3194 4 30.7972 9.64602 13.6278 -24.9284 29.9413 31.6235 -3195 6 52.8163 16.833 29.9704 25.4684 -2.46115 -18.7711 -3196 4 53.1785 16.3479 29.2052 -11.8989 0.938692 6.7974 -3197 4 53.5445 17.4528 30.1342 -3.36222 3.81908 9.3955 -3198 6 13.4835 30.6533 11.9137 -46.9609 -12.8402 15.0292 -3199 4 12.8701 31.2475 12.4314 22.3442 -12.341 -15.3642 -3200 4 14.3315 31.0589 11.9363 20.4041 22.2607 2.0467 -3201 6 24.4145 24.6647 11.1793 -22.2983 -41.6602 -10.5575 -3202 4 25.2113 25.1208 11.3859 27.2622 9.38308 11.5927 -3203 4 24.6402 23.6908 11.0915 -11.4513 27.6962 10.6476 -3204 6 11.1203 26.798 5.92715 -0.288466 28.8994 -0.991584 -3205 4 11.4516 26.991 6.8143 4.21529 -7.59652 -0.673238 -3206 4 11.0194 27.7223 5.58288 -7.6649 -30.4822 0.0195949 -3207 6 12.0071 32.3096 4.57291 -4.86243 14.2275 -68.6847 -3208 4 11.7793 31.9281 3.63093 8.01684 14.4954 56.5286 -3209 4 12.2995 33.2463 4.37904 -4.11207 -26.5611 6.70158 -3210 6 6.4322 5.49281 30.4716 35.2368 -18.2726 5.22228 -3211 4 6.85856 6.3256 30.2181 -6.14256 4.86399 -3.96588 -3212 4 5.49729 5.53619 30.4137 -26.8093 16.306 -3.74387 -3213 6 38.1866 39.6 29.3849 -55.2477 -18.0227 -31.7741 -3214 4 37.4363 40.1798 29.0864 28.3626 1.3397 12.8196 -3215 4 37.8398 38.7214 29.0428 28.3274 26.4583 13.0641 -3216 6 52.5811 19.3636 5.41604 51.907 48.1011 -36.5249 -3217 4 52.4834 20.3242 5.17263 -20.1975 -32.0404 8.71389 -3218 4 53.4908 19.2453 4.99747 -31.6145 -20.6418 25.5541 -3219 6 18.3356 9.8205 21.0747 -17.6268 -29.6196 -17.636 -3220 4 17.8021 9.40634 20.3533 -1.88913 9.35392 27.897 -3221 4 19.0546 10.1733 20.5835 25.9839 20.5094 -7.72749 -3222 6 14.4924 41.1161 15.0432 10.1364 3.71296 -9.89663 -3223 4 15.2732 41.1462 15.6022 9.62288 -5.62086 4.10329 -3224 4 13.9031 41.7078 15.5102 -8.32301 1.75038 3.32266 -3225 6 35.9996 23.9069 26.7492 18.6837 -25.8156 -39.8793 -3226 4 35.9246 23.4421 27.5469 -8.45021 -0.659318 44.9575 -3227 4 36.3072 23.1381 26.2025 -8.08285 36.2837 5.17172 -3228 6 35.634 10.4286 26.2543 -16.0886 -36.8378 31.8954 -3229 4 36.0318 10.4196 25.4062 11.0324 6.64788 -31.8122 -3230 4 35.4344 9.46932 26.4326 4.10196 23.0818 -6.20158 -3231 6 45.3004 24.2842 20.2749 24.2383 10.4641 7.4623 -3232 4 45.3515 25.0535 19.6808 2.20237 -7.91345 -3.22769 -3233 4 44.5434 23.7522 20.0895 -20.4117 -5.11737 -13.922 -3234 6 15.8182 39.0515 24.2407 12.965 16.6456 0.954929 -3235 4 15.3741 39.8779 24.5544 7.5658 -17.411 -0.0196462 -3236 4 16.7724 39.3066 24.1247 -29.8541 -4.22386 6.92178 -3237 6 4.60659 25.9073 16.8122 1.83212 2.60998 -1.97709 -3238 4 5.31562 26.4095 17.2499 -5.00617 -6.2898 0.278133 -3239 4 3.79975 26.4302 16.9186 11.5163 2.87992 -0.585475 -3240 6 33.4767 9.9887 32.5701 -44.5277 -5.18869 -27.5725 -3241 4 34.322 10.1593 32.8843 54.6618 16.656 18.5178 -3242 4 33.0203 9.70843 33.3575 -8.70161 -12.0001 8.14623 -3243 6 22.9321 37.514 1.50284 -0.19108 -28.0604 17.8877 -3244 4 23.0149 38.2279 2.13297 1.92014 9.99004 7.14626 -3245 4 22.7552 36.7067 2.06858 1.19451 21.8657 -20.5647 -3246 6 39.1248 20.5474 25.4766 21.2332 -16.8391 26.0428 -3247 4 39.2186 21.3943 25.0643 2.22233 17.645 -5.02625 -3248 4 39.853 20.5019 26.1611 -16.83 0.667515 -19.8449 -3249 6 25.0699 25.071 37.6104 17.3941 16.9986 -26.7924 -3250 4 25.9994 25.4036 37.6322 -19.4928 -16.3283 1.07636 -3251 4 24.8822 24.8366 38.5108 -1.54859 -5.98321 18.8059 -3252 6 12.2108 35.7702 11.4211 -21.274 -0.450661 -24.3109 -3253 4 11.4942 36.1177 10.8268 17.2098 -2.57945 23.3101 -3254 4 12.7534 35.3113 10.7723 8.20233 4.40137 5.7707 -3255 6 42.0318 15.7212 20.1319 23.9789 -4.66934 -19.8056 -3256 4 42.573 15.4482 19.3354 -11.2719 11.6022 18.1956 -3257 4 42.3198 16.6222 20.3614 3.24172 -2.08619 -3.65764 -3258 6 53.203 25.4276 39.527 3.00787 -13.9161 6.63788 -3259 4 53.7641 25.8569 38.8977 9.18601 6.10619 -8.92001 -3260 4 52.4886 26.0297 39.6953 -12.4398 9.9207 3.51955 -3261 6 53.7999 21.7704 1.29423 13.4333 -6.07506 22.1965 -3262 4 54.6908 21.5389 0.969279 -9.57261 -3.1085 -1.99035 -3263 4 53.3016 22.2177 0.619486 -6.56312 6.61298 -22.2093 -3264 6 1.93757 22.4543 20.1748 -8.22485 -1.41006 19.3874 -3265 4 1.60089 23.2534 20.6505 8.04613 -19.7643 -7.74833 -3266 4 2.27012 21.8339 20.8623 2.42307 18.0741 -7.93574 -3267 6 41.1802 16.179 11.484 -8.24259 53.7733 14.6683 -3268 4 40.8475 15.3772 11.8508 -2.32532 -30.9762 7.10209 -3269 4 40.6167 16.8825 11.9353 16.6943 -22.3779 -21.294 -3270 6 17.1967 38.6113 9.60334 5.35995 -1.86267 -8.12923 -3271 4 17.7852 38.6361 10.3521 13.641 -0.452934 12.0217 -3272 4 16.3282 38.6029 9.98982 -18.6262 -0.708432 10.1602 -3273 6 33.1969 12.9538 38.5484 12.352 25.5713 -8.86638 -3274 4 33.6486 13.824 38.4674 -8.05485 -18.2555 -5.8969 -3275 4 33.0335 12.8861 39.4897 4.37007 -7.66636 -4.23751 -3276 6 24.7228 21.6957 39.9776 0.331302 -26.4697 -8.75647 -3277 4 24.5832 21.6143 39.0045 0.235774 0.581704 12.5709 -3278 4 25.2663 20.9218 40.2505 -4.0265 10.6546 -4.86064 -3279 6 13.577 15.5497 27.3411 27.7809 44.9786 27.5516 -3280 4 13.196 16.0821 28.0648 5.30872 -0.0493108 -10.0398 -3281 4 12.9031 14.935 27.2057 -29.8548 -39.4113 -11.0219 -3282 6 24.6863 18.7248 9.26482 -8.80414 -2.51529 14.0236 -3283 4 25.3563 19.2311 8.7609 -6.6335 -0.338001 12.1858 -3284 4 24.3761 19.0911 10.1338 17.243 1.91927 -22.7003 -3285 6 10.9743 8.21046 0.042398 -18.7759 13.8117 62.0104 -3286 4 10.3469 8.74796 0.639501 28.6352 -16.9877 -21.8389 -3287 4 11.7753 8.08291 0.592641 -4.28958 7.52309 -10.9298 -3288 6 15.7499 31.9609 31.3743 -17.6212 -20.5964 15.467 -3289 4 14.8817 31.9157 30.9761 -10.6343 5.00824 -7.09118 -3290 4 16.0827 32.8403 31.1978 10.1106 0.369155 -2.88897 -3291 6 20.3726 39.1695 21.6147 20.5981 -29.5513 41.0934 -3292 4 19.9726 38.3531 21.9994 -5.82675 23.323 -22.8284 -3293 4 21.1172 39.24 22.2595 -11.0324 14.4144 -20.0969 -3294 6 38.8594 19.5251 7.6091 -6.47304 13.0289 -25.1371 -3295 4 38.0017 19.0955 7.57416 -1.20877 -0.517864 1.64758 -3296 4 39.1744 19.3685 8.48411 8.18586 -10.9486 17.219 -3297 6 41.3695 29.7301 21.1465 -57.7285 -14.4296 34.1578 -3298 4 41.7832 29.6286 20.3251 24.9116 3.74799 -36.1007 -3299 4 41.9865 29.9579 21.8177 26.2541 9.18996 12.3917 -3300 6 50.7039 33.8333 22.0593 7.50244 -20.9835 17.6314 -3301 4 50.9654 32.9474 22.4123 -1.20949 24.7473 -8.4765 -3302 4 50.362 33.6446 21.1779 1.66119 1.27804 -3.63001 -3303 6 18.1671 11.1714 14.3658 -12.4278 -6.78987 13.7569 -3304 4 18.0724 11.2679 15.338 -0.312443 2.59996 -20.4321 -3305 4 19.115 11.0923 14.227 4.83391 -0.924272 -3.79066 -3306 6 48.5058 14.2689 15.2513 -36.7782 -21.7282 -18.3567 -3307 4 49.3677 14.5693 15.4148 44.1026 10.3807 8.68918 -3308 4 48.5803 13.5893 14.5426 -8.44167 10.5166 12.8885 -3309 6 32.9801 15.74 8.25484 19.5805 1.81858 6.30948 -3310 4 33.8151 15.5666 7.78828 -7.72407 0.576521 2.61047 -3311 4 33.2057 15.7253 9.21147 -5.47651 1.26655 -15.0149 -3312 6 42.9141 4.85593 18.7596 35.6338 16.8786 18.3104 -3313 4 43.0674 5.82698 18.891 -14.0493 -22.2454 -3.89051 -3314 4 43.7794 4.50634 19.0974 -23.5505 0.71427 -17.3058 -3315 6 10.488 23.7131 33.4436 27.6073 45.1219 -14.7699 -3316 4 10.638 24.6985 33.3892 -15.3766 -28.1208 6.63949 -3317 4 11.1638 23.4099 32.8243 -6.46894 -14.1785 5.09081 -3318 6 1.12582 20.0662 11.2775 2.81918 8.09367 56.8435 -3319 4 0.488344 19.3589 11.407 -2.14544 -6.99577 -20.9797 -3320 4 1.17571 20.424 12.22 2.69463 -2.11621 -44.733 -3321 6 1.50824 39.5346 14.3079 -5.25271 -28.0543 15.9462 -3322 4 0.868346 40.1487 14.6984 3.61457 -0.641003 -8.28938 -3323 4 1.2571 38.629 14.6571 12.5115 33.2201 -10.0417 -3324 6 8.3332 21.6069 14.1357 -16.8636 -16.8509 36.8071 -3325 4 8.17334 21.0976 14.9962 5.25323 23.3985 -29.627 -3326 4 7.56323 21.4407 13.5807 -3.95337 3.79773 -2.56685 -3327 6 7.16177 13.3249 38.2255 -6.34169 -18.8056 -1.32195 -3328 4 6.69256 13.0329 37.4043 9.76156 12.0715 20.3406 -3329 4 7.43529 14.2522 38.1581 -0.0118119 -11.8895 -14.491 -3330 6 46.6212 1.64167 18.6867 -0.0463537 -24.1078 41.7639 -3331 4 47.541 1.5611 18.992 -0.862753 9.16913 -10.8716 -3332 4 46.1606 1.36736 19.5239 4.43612 14.9978 -24.7224 -3333 6 4.08147 8.39338 14.788 26.1694 13.8207 2.32184 -3334 4 3.41636 8.28931 15.4347 -29.1417 0.0985708 23.0338 -3335 4 3.90156 7.69349 14.1818 -2.47935 -14.3959 -27.3016 -3336 6 47.5712 36.5372 17.8422 14.6219 44.3363 14.3039 -3337 4 47.1691 35.7037 17.6938 -6.70251 -40.3849 -9.96305 -3338 4 48.5299 36.4434 17.8412 5.708 -14.7801 -1.83759 -3339 6 48.7177 32.6293 3.61477 24.5557 -7.82504 -30.2396 -3340 4 49.3183 32.0587 3.09719 0.221751 18.4164 7.83871 -3341 4 48.4066 32.0299 4.25286 -21.3126 -17.4552 36.5328 -3342 6 26.8672 34.4113 15.184 7.18591 -12.831 -4.85448 -3343 4 27.1806 33.7337 15.7866 -5.2278 -3.11582 5.08403 -3344 4 27.3382 34.1395 14.3734 -5.71629 20.1707 6.74573 -3345 6 9.99603 27.3398 13.3337 -11.5184 -70.0362 -20.4383 -3346 4 9.96963 28.1856 12.9595 -3.0362 48.3298 -16.8459 -3347 4 9.789 26.7159 12.5598 12.8825 26.2078 29.4693 -3348 6 2.39106 26.8936 37.3456 -18.0299 -5.48602 7.48259 -3349 4 2.24944 26.7597 38.2955 12.6258 0.126767 -1.18485 -3350 4 3.33209 26.9598 37.1993 18.2818 -0.192027 1.55797 -3351 6 33.3384 17.273 36.7956 -4.69576 6.00605 30.6641 -3352 4 32.3777 17.4022 36.9421 6.35755 -1.66054 -12.3647 -3353 4 33.5147 17.1107 35.8745 -6.55426 -0.461729 -19.8283 -3354 6 10.6704 18.7989 9.29568 -2.62714 4.796 -4.28658 -3355 4 10.7729 18.8103 8.31395 -3.57004 -0.312677 18.1362 -3356 4 10.9356 19.679 9.6198 -4.15772 -1.10699 -11.1079 -3357 6 8.58029 27.4085 3.13543 -0.646896 -38.9365 14.7517 -3358 4 8.62134 27.4642 4.10772 -2.35878 18.0768 -8.00568 -3359 4 8.54298 26.4189 3.06204 -3.80038 30.3142 -4.62402 -3360 6 40.6121 33.9148 14.3433 -13.4775 28.2536 -12.7531 -3361 4 40.8898 33.2957 14.9932 8.13038 -23.145 12.8628 -3362 4 40.1237 34.5547 14.8716 -1.64981 1.12342 -7.13376 -3363 6 54.0126 16.7742 13.6402 -25.2384 12.1291 10.4483 -3364 4 54.0311 17.2666 12.8352 12.7766 5.78776 -30.0788 -3365 4 53.1083 16.9555 13.9311 3.38038 0.740926 17.4694 -3366 6 39.1613 38.4947 7.40674 -49.2832 -1.36929 38.9537 -3367 4 38.8094 38.4839 6.52049 1.87105 5.40513 -14.0728 -3368 4 38.3203 38.5292 7.99504 41.7155 2.10662 -28.5328 -3369 6 42.2152 33.6749 29.0207 -49.4578 14.7313 -27.4402 -3370 4 42.0113 34.6279 28.8262 15.7605 -21.0767 3.4048 -3371 4 41.3749 33.2313 28.6743 34.021 9.03137 24.2205 -3372 6 2.84529 0.06018 20.1342 1.75144 -0.125494 -5.27144 -3373 4 2.85876 0.453048 19.2323 -10.3946 -7.40064 8.89792 -3374 4 1.95714 41.5787 20.3005 13.5701 9.63706 -6.70109 -3375 6 24.9846 26.9367 24.435 4.97654 17.1262 30.4362 -3376 4 25.3707 26.0628 24.5275 -2.48626 -13.7157 -10.817 -3377 4 25.1946 27.3852 25.2847 -1.69157 -3.92554 -20.3381 -3378 6 13.6202 33.989 7.00835 -29.3159 10.7937 -13.6787 -3379 4 14.4707 33.6317 6.76766 5.19255 -3.31821 -12.8703 -3380 4 13.1262 34.2356 6.16936 24.7045 -4.21039 25.9053 -3381 6 17.6361 31.8361 3.38698 11.6752 63.8731 -26.646 -3382 4 17.3765 32.06 2.46015 3.81419 -8.12146 27.658 -3383 4 17.5414 30.922 3.45915 -17.4061 -53.1647 5.72422 -3384 6 31.114 29.8463 35.9142 20.4735 12.0385 -23.871 -3385 4 30.4046 29.6578 36.4892 -25.9224 -10.1565 23.4082 -3386 4 31.8798 29.3863 36.2596 4.49336 -0.641295 3.24883 -3387 6 31.4544 1.69927 1.93203 61.0942 61.1307 23.4408 -3388 4 30.847 1.03155 1.81447 -56.5376 -48.8621 -2.33617 -3389 4 31.1234 2.33851 2.60628 -4.67927 -17.7811 -18.4359 -3390 6 13.7206 9.35179 12.308 -20.4886 -14.5553 22.3614 -3391 4 13.8994 10.2254 12.0406 16.2488 33.284 -13.5816 -3392 4 13.1923 9.47724 13.1212 6.47756 -14.062 -7.29461 -3393 6 15.2915 15.1706 12.1407 -39.3514 -20.6771 -15.8676 -3394 4 14.288 15.1355 12.0691 34.6095 3.19954 13.2467 -3395 4 15.5721 14.5705 11.433 2.70369 1.94224 0.817449 -3396 6 44.9298 30.4448 13.0945 -83.0621 -13.8007 20.4391 -3397 4 45.2326 30.6692 13.9612 22.7288 5.76966 14.7184 -3398 4 45.5619 30.4921 12.4362 58.1466 4.79773 -38.6719 -3399 6 35.1494 37.6283 24.8564 -28.9971 -18.9514 34.2227 -3400 4 34.5453 38.351 25.1691 15.7809 -12.2194 -9.31628 -3401 4 34.8969 36.8477 25.46 15.2444 28.3361 -22.0595 -3402 6 43.9018 19.2999 12.9893 -4.23684 -28.8047 14.7243 -3403 4 43.7111 18.3276 12.9437 8.07938 21.0179 -2.3859 -3404 4 44.434 19.3703 13.8064 -8.2748 4.27416 -6.23054 -3405 6 14.1928 27.3824 16.8974 17.9721 24.801 -15.5057 -3406 4 13.3941 26.8971 17.049 -12.9837 -13.2841 -1.45311 -3407 4 14.075 27.8458 16.0392 0.928992 -14.2323 10.6565 -3408 6 5.07867 37.4759 15.7278 -19.2695 5.34987 61.0101 -3409 4 5.83402 37.4907 16.3496 5.41141 -1.20808 -8.02024 -3410 4 5.40595 37.3511 14.8725 27.2981 -13.142 -45.6678 -3411 6 35.4792 36.9736 33.2279 -33.1303 3.22524 14.2013 -3412 4 36.4062 37.0387 33.1707 43.394 6.70104 -6.41693 -3413 4 35.2647 37.5361 33.9926 -10.1497 -5.08286 -5.32556 -3414 6 6.63713 31.7122 32.9951 -15.6769 -13.4095 -29.903 -3415 4 7.30356 31.0631 32.7808 0.413821 -11.0386 -1.85208 -3416 4 7.01801 32.1732 33.7097 9.96672 21.2943 24.541 -3417 6 31.2686 20.2272 25.4717 1.63607 -11.2998 14.888 -3418 4 30.457 20.1188 26.0175 18.7046 8.55246 -6.40474 -3419 4 30.9671 20.3507 24.5747 -9.02709 8.2981 -6.80006 -3420 6 54.9594 26.0897 7.3541 -26.2324 -3.52234 4.1817 -3421 4 54.3149 26.536 6.76189 8.45344 -4.14623 9.81761 -3422 4 54.4064 25.6921 8.06559 9.60693 6.10548 -13.0393 -3423 6 17.8786 35.1581 24.3912 -48.4608 -31.2574 -23.2844 -3424 4 17.9034 34.576 25.1672 15.4891 12.513 -1.90366 -3425 4 17.14 34.695 23.8716 34.0055 23.8611 10.1154 -3426 6 49.1404 3.30993 19.753 -11.7437 -5.45724 -22.9314 -3427 4 48.7379 4.07245 20.162 -0.785462 12.6857 6.5087 -3428 4 49.8408 3.03849 20.3377 4.84054 -6.57183 8.59361 -3429 6 30.2791 35.6014 13.4902 -0.275976 1.62471 9.45881 -3430 4 29.4038 35.7322 13.1068 5.01216 -3.78726 -8.18413 -3431 4 30.1007 35.4484 14.4302 1.26073 -0.50544 -4.60872 -3432 6 43.3857 25.8788 41.6729 -28.3599 -13.2186 -4.43344 -3433 4 44.0236 25.6058 41.0289 13.0372 -2.28568 -15.7328 -3434 4 43.8192 26.4334 0.378509 18.4346 21.3926 23.5205 -3435 6 21.1033 23.1572 6.40534 -12.8895 6.60285 13.2505 -3436 4 21.2833 23.9599 6.94372 3.68538 -20.4677 -7.26612 -3437 4 21.2354 23.4378 5.50624 8.61756 6.39287 -19.4039 -3438 6 54.6209 21.1977 19.0953 -9.4905 16.5472 15.3455 -3439 4 0.355231 21.543 19.6762 -10.082 -5.94448 -19.8865 -3440 4 53.803 21.6498 19.4211 22.178 -8.62035 -3.94206 -3441 6 13.8696 38.9444 18.7589 -0.408574 -9.95072 10.686 -3442 4 13.5473 38.5195 19.5701 -4.79749 -3.34053 -10.6661 -3443 4 14.2783 39.7511 19.0654 -4.68159 17.5572 -2.41189 -3444 6 39.1837 2.73799 39.6933 -2.22487 -14.248 -19.2211 -3445 4 38.5048 2.18054 40.1045 3.50502 9.25929 9.72195 -3446 4 39.1752 2.3966 38.7788 -3.09486 7.3066 6.14055 -3447 6 43.2236 33.8218 8.83748 -23.7799 54.6507 -8.87946 -3448 4 43.1776 32.9835 9.22653 -2.14792 -45.6212 21.4927 -3449 4 42.4318 34.327 9.18683 27.5752 -12.6709 -4.85681 -3450 6 23.0768 16.6786 12.1043 19.2201 -8.5648 -22.0864 -3451 4 23.4688 16.2415 11.3109 -7.42341 7.06352 19.0042 -3452 4 22.1329 16.714 11.9048 -3.02708 6.60369 6.72608 -3453 6 40.7875 26.1445 36.3165 -31.0446 26.1707 15.63 -3454 4 40.1182 26.8831 36.2336 22.2291 -27.8038 4.66075 -3455 4 41.0346 25.9172 35.4285 12.0382 -0.567557 -16.236 -3456 6 15.1503 11.6728 19.298 -10.8743 -20.3409 15.6657 -3457 4 15.4707 12.2619 18.6272 13.0208 17.9076 -10.0848 -3458 4 15.518 11.9699 20.1418 -0.780585 5.28883 -4.88637 -3459 6 9.8485 29.8084 31.3808 31.6725 31.0987 -15.032 -3460 4 10.6075 30.172 31.8684 -9.75043 -12.6573 12.7307 -3461 4 9.98584 30.2945 30.5336 -20.1344 -22.7331 8.89086 -3462 6 2.12557 30.0341 25.264 -3.96851 -24.8252 -11.595 -3463 4 2.04755 29.1979 25.7442 2.8488 12.5065 4.07713 -3464 4 2.06741 29.7398 24.3306 5.27272 21.1251 20.17 -3465 6 49.0124 10.6515 7.04668 12.8278 -6.79775 19.6819 -3466 4 49.7765 10.456 7.62014 -4.12072 9.88663 -9.32692 -3467 4 48.4954 9.84699 7.16976 -12.5497 -3.43755 -7.74842 -3468 6 38.6385 34.4247 32.4851 8.7415 15.3068 2.26745 -3469 4 38.2449 35.2411 32.8392 7.79483 -2.42751 -9.0272 -3470 4 38.3877 33.7513 33.1114 -5.41613 -8.85245 5.88093 -3471 6 24.2967 24.7175 4.7858 -13.8074 20.2372 -8.25903 -3472 4 24.5879 23.8747 5.12331 8.49271 -10.4438 10.0312 -3473 4 24.0688 25.3355 5.52385 7.10746 -21.4288 -14.6014 -3474 6 44.0211 23.587 33.7713 -18.8641 -18.6234 -6.9532 -3475 4 43.6265 23.0569 33.047 -3.30007 6.44469 22.3225 -3476 4 44.7839 23.9213 33.3479 32.8249 22.1868 -7.88886 -3477 6 45.135 31.9539 26.6318 17.8742 -16.5206 -32.2352 -3478 4 44.6965 32.0125 27.458 -12.8805 4.46476 28.7394 -3479 4 45.0195 31.023 26.337 -1.34861 17.8758 10.4404 -3480 6 52.0545 6.36303 22.865 -1.87051 -30.929 -4.90791 -3481 4 51.4549 5.58836 23.0553 13.7734 29.2588 0.606927 -3482 4 51.4955 7.14596 22.8951 -3.5837 -3.73437 -5.39564 -3483 6 5.1124 17.7016 30.4663 -17.3022 -2.39818 -4.94531 -3484 4 5.57517 17.705 29.6436 5.33167 -14.42 -26.4334 -3485 4 5.6774 18.2653 30.9495 12.7188 16.8745 32.2475 -3486 6 48.5399 17.0091 6.52669 31.3107 25.6813 -22.3666 -3487 4 48.2466 16.108 6.56632 -4.44525 -18.5722 0.0807757 -3488 4 49.3123 17.0767 5.87973 -32.0368 -4.22047 21.2267 -3489 6 13.8017 31.3286 23.4652 -45.3568 -0.340859 23.461 -3490 4 14.0246 31.2001 24.3905 13.6426 -1.74144 -0.768444 -3491 4 14.5269 31.1963 22.8948 44.8358 -8.96568 -14.3918 -3492 6 28.4984 33.4231 26.025 30.2115 45.129 -4.70205 -3493 4 28.7629 32.7421 25.4284 0.749934 -18.6264 -12.7861 -3494 4 27.7356 33.1626 26.4825 -33.9251 -20.2776 22.3239 -3495 6 9.04101 22.9533 11.0101 4.17271 5.63899 8.67886 -3496 4 9.24243 22.776 10.0879 9.05926 -1.29962 -0.957415 -3497 4 9.84172 22.774 11.5341 -6.79246 0.647577 -9.3095 -3498 6 40.5624 4.0706 26.5792 43.7479 -58.1273 15.512 -3499 4 40.0377 4.03321 27.356 -14.6911 0.39925 31.4188 -3500 4 40.1771 4.74143 26.1095 -33.6389 57.2603 -43.6855 -3501 6 17.0606 37.9689 20.9328 24.9068 -2.83666 19.2437 -3502 4 17.7492 37.7057 21.5806 -0.23423 0.332892 -22.3637 -3503 4 16.3 37.9671 21.4825 -28.3901 -0.1668 6.57955 -3504 6 31.9758 6.36253 14.1925 -47.1359 -2.961 8.2158 -3505 4 31.6652 5.47044 14.4516 -0.57512 5.53961 -9.89258 -3506 4 32.9075 6.27907 14.242 33.1863 -3.34593 -3.73058 -3507 6 29.3613 34.9484 39.6522 -7.7658 6.78361 -10.4711 -3508 4 29.4154 34.7255 40.5688 2.48129 -3.65799 19.6008 -3509 4 28.4079 35.1232 39.5563 9.75382 -5.50564 -9.65046 -3510 6 22.5642 2.93231 32.1024 7.89654 -13.571 4.24933 -3511 4 23.152 3.60479 31.7467 -0.797152 8.5773 -0.128413 -3512 4 22.8746 2.10235 31.6905 -8.86372 14.3523 0.842504 -3513 6 51.7365 19.0888 24.8036 24.4352 10.6631 34.2631 -3514 4 52.2011 19.3182 25.6664 -22.8444 -5.9403 -33.5217 -3515 4 52.2256 19.5376 24.1035 -3.13425 5.18677 -1.50107 -3516 6 32.1309 13.661 24.2221 8.32979 -1.22201 -48.3483 -3517 4 32.1718 13.7834 25.1379 3.34806 7.10631 53.6256 -3518 4 31.2192 13.5434 23.9915 -25.9097 -1.66347 2.1781 -3519 6 9.49478 30.1756 28.7975 -1.02802 7.68553 8.51386 -3520 4 8.9614 29.4447 28.4635 3.13242 -3.87437 -3.11369 -3521 4 9.76139 30.7024 28.0341 -4.99689 -6.39164 -2.13333 -3522 6 31.3017 3.1328 24.0821 -2.56057 -13.3126 7.41322 -3523 4 30.8642 3.97896 23.9468 1.03353 -0.10231 -3.56587 -3524 4 32.1597 3.13825 23.6386 1.18226 10.803 -0.447916 -3525 6 2.13915 19.8328 36.4477 43.9795 26.8161 3.66972 -3526 4 3.0929 19.9274 36.115 -41.9598 -16.8793 8.64164 -3527 4 1.76662 18.9777 36.2517 -5.24508 -9.86619 -11.2286 -3528 6 36.9558 16.7701 14.0992 8.10199 -24.1685 -1.60142 -3529 4 37.0878 17.1202 14.9938 -3.44507 3.84646 -3.58016 -3530 4 37.3137 15.854 14.1066 -5.27996 15.1268 -1.92478 -3531 6 1.82451 11.1811 6.08431 4.75441 9.84221 -14.5701 -3532 4 1.68522 10.3449 6.52934 -2.64515 -5.74712 4.44833 -3533 4 1.45572 11.848 6.66197 -6.16769 2.71123 7.45582 -3534 6 43.1467 36.8536 25.2684 -4.34259 -25.2275 5.76074 -3535 4 42.489 36.6679 24.5813 -1.65581 9.08703 8.09798 -3536 4 42.9757 36.1566 25.9418 7.67001 18.3814 -10.5814 -3537 6 32.1358 5.54258 7.00813 -0.159667 5.03525 -3.02009 -3538 4 31.8447 4.70695 7.37259 1.76357 -8.94122 3.22744 -3539 4 31.6184 6.21523 7.45425 -7.92944 5.35442 3.67752 -3540 6 15.0738 21.498 41.5176 2.48253 -6.99424 4.64434 -3541 4 14.4083 21.441 0.286083 -5.89506 -4.91034 13.0846 -3542 4 14.6326 22.02 40.8608 1.523 7.8898 -22.5967 -3543 6 37.0299 36.0573 5.68999 -1.26402 -4.33671 -4.68257 -3544 4 36.8992 36.8706 5.1864 -9.04185 9.38437 4.54051 -3545 4 36.6368 36.1345 6.57983 4.68584 5.64444 -6.17041 -3546 6 39.6378 22.8733 0.344261 -10.4835 1.90991 -1.04201 -3547 4 39.8967 23.7127 41.8596 6.32696 2.65577 1.7872 -3548 4 39.7641 22.9598 1.30287 2.84221 -4.68177 2.22816 -3549 6 18.471 23.1695 5.24444 18.17 13.8994 5.32385 -3550 4 18.2426 24.0888 5.07969 -12.1406 8.45165 -11.681 -3551 4 19.3434 23.2774 5.65727 -5.17221 -14.3673 2.51868 -3552 6 34.4951 26.4012 0.415196 -24.2262 -21.8504 23.5375 -3553 4 33.9567 27.1096 0.873351 15.2264 -25.8266 -5.88921 -3554 4 34.3584 25.5285 0.919462 6.17703 40.7497 -12.3351 -3555 6 28.1538 26.089 40.6186 -44.0465 -12.7539 23.8091 -3556 4 29.0676 25.9468 40.8623 9.74545 0.451611 8.45277 -3557 4 27.5517 25.6856 41.3354 31.2048 15.0133 -28.9196 -3558 6 41.7541 4.40312 30.2348 -21.1804 7.97019 15.7848 -3559 4 42.5951 3.9554 30.1474 10.5948 -6.90465 6.49815 -3560 4 41.6197 4.66064 31.1807 9.39609 -4.15263 -13.0838 -3561 6 4.45746 8.30422 29.123 17.0584 8.0822 12.8675 -3562 4 3.72424 8.78851 28.7689 -20.5564 0.917363 -10.5697 -3563 4 4.90241 9.00738 29.631 2.39094 -12.8625 -4.67793 -3564 6 12.9051 9.61174 32.1485 9.54391 19.7002 1.20842 -3565 4 12.5238 8.90328 31.6499 -4.6135 -18.7028 0.941221 -3566 4 13.4507 9.29961 32.8815 -5.77341 -6.01915 -0.606497 -3567 6 48.6524 16.2364 1.45279 -39.5117 19.3379 22.5337 -3568 4 49.5656 16.3395 1.57323 44.82 -2.42546 -4.76282 -3569 4 48.322 16.6449 2.29127 -2.06599 -18.2277 -23.678 -3570 6 26.4391 39.9942 21.1964 -5.73 55.7886 4.05886 -3571 4 27.1886 40.6225 21.0926 -13.7426 -7.13397 8.25982 -3572 4 26.7825 39.1793 20.9147 12.833 -38.7313 -7.54244 -3573 6 35.8074 4.09236 9.03492 -45.4698 -15.3304 -15.5709 -3574 4 35.5046 4.67089 8.30824 2.24043 1.80806 6.22839 -3575 4 34.9768 3.81452 9.52186 26.5657 10.3238 -8.47709 -3576 6 52.6895 3.55751 27.8666 50.2867 -19.9176 -34.5196 -3577 4 53.5586 3.5996 28.3549 -33.5645 -3.53647 -1.9565 -3578 4 53.0019 3.22463 26.9489 -24.4009 21.759 36.9675 -3579 6 48.3192 26.6913 27.3954 13.1896 -37.7442 -6.45526 -3580 4 48.9722 25.929 27.4853 -22.116 34.446 0.770506 -3581 4 48.7243 27.4862 27.7371 6.43066 9.80699 11.7315 -3582 6 24.507 4.96042 18.7259 -17.59 -10.4057 14.9036 -3583 4 24.0519 4.20246 19.1729 14.2279 16.3534 -10.8515 -3584 4 23.9406 5.7442 18.8517 8.31711 -9.56192 -0.149656 -3585 6 24.0493 12.473 28.7688 20.4432 11.2466 2.34496 -3586 4 23.2439 12.9627 28.9427 -11.3477 -3.77152 -2.6943 -3587 4 23.8404 11.6087 28.4204 -6.74951 -3.90152 -5.01594 -3588 6 40.1637 27.7353 40.8087 -33.5791 -9.4694 0.953173 -3589 4 40.5641 26.9832 41.236 1.78301 2.25495 0.260865 -3590 4 39.2218 27.4214 40.7917 21.7476 20.7917 -9.34619 -3591 6 11.9335 13.5538 26.9488 -1.21599 4.57236 -11.9259 -3592 4 11.0364 13.8177 27.1576 -7.67129 -6.9102 2.53909 -3593 4 12.2164 12.9501 27.6309 4.70555 -13.4351 6.55277 -3594 6 52.1924 29.5424 41.3942 11.5626 -24.8936 -19.0003 -3595 4 51.8104 30.1965 0.050158 4.44506 23.3375 14.6186 -3596 4 53.1351 29.3771 41.6391 -10.5303 1.44862 4.74126 -3597 6 17.4882 19.0285 39.1853 -8.07927 32.7478 0.0743051 -3598 4 17.5012 19.6463 39.9647 -0.891206 -23.8414 -20.0908 -3599 4 17.261 19.5796 38.3923 8.05332 -16.519 21.1694 -3600 6 46.2326 27.6801 33.704 6.45393 -8.86534 7.23017 -3601 4 46.097 28.3723 33.048 -4.6559 5.79968 -1.93617 -3602 4 45.5979 27.7746 34.4233 -3.33861 16.4707 5.34235 -3603 6 35.8364 29.5448 5.62541 9.64171 -18.9009 -6.27826 -3604 4 35.5566 29.3199 4.72548 3.62776 14.0584 -3.56087 -3605 4 35.3944 30.354 5.86953 -6.57081 16.5188 2.47276 -3606 6 47.2881 25.7744 30.172 -6.62968 25.0044 -44.0548 -3607 4 48.1218 25.8653 29.6696 -5.94381 -7.49802 14.0131 -3608 4 46.6882 26.3745 29.6449 8.85802 -15.1094 17.4745 -3609 6 51.3842 12.359 20.0239 24.4626 17.3052 -5.31346 -3610 4 50.8707 12.833 19.3583 -10.0057 -7.98386 3.51527 -3611 4 50.8448 11.6564 20.3722 -11.0446 -8.70835 7.6307 -3612 6 41.976 18.3776 28.9581 25.2971 -7.26912 -18.3725 -3613 4 42.7018 17.9973 28.405 -17.3573 7.64094 3.96866 -3614 4 42.4517 18.9921 29.5246 -2.74764 -0.293653 0.793262 -3615 6 53.6043 6.48027 7.50524 -23.0657 -32.6432 -30.9738 -3616 4 53.1601 5.59498 7.33399 18.2827 28.6912 7.08019 -3617 4 53.6632 6.576 8.44633 9.6706 -3.87944 16.2616 -3618 6 9.90786 10.6094 26.7582 6.17728 8.73826 28.1859 -3619 4 10.299 10.3755 27.6331 -6.59671 -6.24018 -20.7073 -3620 4 9.65116 11.5299 26.9247 0.732239 -5.98194 -12.944 -3621 6 9.31054 39.3957 29.7756 40.7644 23.7808 19.8799 -3622 4 10.1982 39.3563 30.2561 -34.3316 0.809436 -14.8313 -3623 4 8.83679 40.1565 30.1832 5.55001 -15.1294 -12.8037 -3624 6 33.4099 4.77839 0.03236 -17.6047 -18.7695 14.8321 -3625 4 33.6454 5.53147 41.4176 15.8926 12.9618 -7.52592 -3626 4 34.0969 4.09847 41.8942 -0.186489 10.0102 -3.03658 -3627 6 35.7116 10.6673 34.2398 36.7653 -21.2814 -15.2586 -3628 4 35.2554 10.867 35.0388 -18.8422 0.575424 27.4634 -3629 4 36.4577 10.0619 34.4978 -21.6361 17.9445 -5.28322 -3630 6 15.2039 17.4016 19.1867 13.7018 -34.0248 -48.7675 -3631 4 15.5709 16.9982 18.3093 -23.7907 16.5473 43.0322 -3632 4 14.2523 17.472 19.021 -2.02403 4.48523 -0.714523 -3633 6 17.4757 37.6682 15.4227 -5.7624 0.927264 51.2416 -3634 4 17.0409 37.838 16.3209 3.67045 -5.85113 -35.7653 -3635 4 18.3529 37.3927 15.7202 1.879 4.38305 -13.464 -3636 6 26.263 8.20496 21.7043 -12.9193 13.0258 38.8746 -3637 4 26.2935 8.46487 22.6678 13.4631 -3.74504 -28.0146 -3638 4 25.3122 8.09558 21.5911 -4.90698 -1.77416 -12.6216 -3639 6 0.327844 9.89683 15.4174 -28.4002 -4.57955 -27.8061 -3640 4 1.20252 9.6859 15.1701 33.2298 -8.84956 3.25601 -3641 4 54.8213 9.3498 14.7471 -0.695723 21.8052 24.8209 -3642 6 13.451 40.6616 9.29616 -29.1589 -29.1317 3.11657 -3643 4 12.531 40.2581 9.2528 27.9164 27.237 1.6895 -3644 4 13.9533 39.998 9.7876 1.76749 3.89663 -1.50565 -3645 6 49.5605 25.9144 33.0102 6.77982 -23.7672 54.8124 -3646 4 50.0733 25.5846 33.8473 -25.1648 19.9091 -52.5505 -3647 4 48.6275 25.6453 33.15 14.5478 0.915879 -9.46863 -3648 6 37.0796 40.0419 26.4359 -26.9931 13.9721 12.3681 -3649 4 36.1882 39.5442 26.6099 42.8933 36.2545 -2.50818 -3650 4 37.051 41.026 26.6764 -12.8506 -44.3362 -9.04112 -3651 6 47.9916 17.8545 12.1553 -7.21137 29.6324 -37.7219 -3652 4 47.6652 18.6843 11.7058 6.42171 -29.0319 9.52509 -3653 4 47.7397 17.941 13.056 -8.12129 -2.80141 29.1943 -3654 6 27.9724 29.0571 34.165 6.45289 -21.5611 -2.40729 -3655 4 28.8948 28.8211 34.3683 -10.3018 1.8492 -2.91154 -3656 4 27.944 30.0064 34.1676 -0.713497 24.9251 0.854011 -3657 6 33.997 2.77014 13.2231 -35.3168 39.3397 6.14274 -3658 4 33.7592 2.40426 14.0871 -4.38792 -6.80294 -4.34532 -3659 4 34.7545 2.32608 12.931 40.4814 -27.3629 -5.76242 -3660 6 28.4454 36.033 11.4537 -30.811 -5.98685 22.1865 -3661 4 27.9997 35.3658 10.9161 0.521783 -1.73573 4.3727 -3662 4 28.9676 36.474 10.8303 31.7187 19.1344 -28.008 -3663 6 36.1836 11.3675 28.8638 -20.2526 -8.96451 -46.9053 -3664 4 35.201 11.3136 28.8426 17.393 5.15327 13.3727 -3665 4 36.3619 11.2493 27.8855 5.85658 3.26624 29.9739 -3666 6 24.7946 39.4802 16.9069 19.0937 3.96627 -8.4872 -3667 4 24.3751 40.345 16.9988 -5.97342 -3.52606 0.908874 -3668 4 24.9466 39.3518 15.9585 -10.9099 3.48913 2.54936 -3669 6 49.9504 8.05659 22.8451 -38.4139 -9.47108 -34.4931 -3670 4 49.9375 7.9588 23.7925 -16.1787 -3.75115 16.4902 -3671 4 49.0231 7.8493 22.4633 39.8101 3.17892 24.2331 -3672 6 52.1004 19.3469 10.2236 -1.12118 28.0811 1.24376 -3673 4 51.6057 19.3908 9.40186 -4.74475 -17.9853 -5.36861 -3674 4 52.3066 20.3081 10.2872 8.90847 -30.6944 7.30622 -3675 6 24.8344 15.8907 6.13046 -10.5287 3.62194 6.20212 -3676 4 24.2343 16.3288 6.78807 10.5214 -9.32926 -18.7028 -3677 4 24.4584 16.0701 5.24836 4.34413 4.47582 9.48796 -3678 6 49.3142 23.7074 8.6354 12.7826 -64.5552 32.8663 -3679 4 49.2168 22.9153 9.25307 13.1077 36.9849 -24.4484 -3680 4 48.4233 23.9587 8.46247 -20.5325 16.4959 -12.9251 -3681 6 0.200228 10.6387 32.1899 4.57462 9.08702 -50.3173 -3682 4 1.12405 10.3631 32.1441 4.84637 -6.06001 20.7538 -3683 4 54.8206 10.7585 33.0477 -1.25869 -8.0958 33.7963 -3684 6 12.5866 32.9145 13.2359 -45.84 -1.33101 12.3773 -3685 4 11.7384 33.4448 13.1799 26.1773 -16.8128 -1.90055 -3686 4 13.2757 33.4614 12.9111 20.4647 17.7705 -9.07485 -3687 6 21.729 32.5695 14.1172 -9.28791 -20.3928 5.37861 -3688 4 21.166 33.3661 14.1597 2.78901 -9.86158 3.94413 -3689 4 21.3002 31.8069 14.587 7.27427 31.5827 -10.8786 -3690 6 48.1522 34.8482 27.3304 1.15431 -17.6089 -40.5894 -3691 4 47.5385 35.1725 27.9994 -6.04073 -2.93057 -0.479876 -3692 4 47.6796 34.4132 26.5454 8.99615 21.2578 35.6726 -3693 6 45.6357 31.2393 36.095 -40.8957 20.4658 25.2026 -3694 4 45.8476 31.9489 35.493 1.2761 6.76392 -14.6383 -3695 4 44.8829 31.5945 36.6582 19.8537 -10.4851 -18.3708 -3696 6 46.2846 0.316369 14.3569 -23.6541 -29.5796 11.0344 -3697 4 46.2347 1.24867 14.1822 6.12226 14.592 -0.646978 -3698 4 47.172 41.8876 14.3137 22.6277 5.76419 -11.0491 -3699 6 14.3437 18.9821 40.2104 -25.2995 -33.3041 -15.9392 -3700 4 14.4094 19.2869 39.3238 4.54227 2.45102 -23.4893 -3701 4 14.593 19.7098 40.7196 18.3341 34.8836 33.2243 -3702 6 14.5595 1.13832 10.2184 21.0915 11.237 11.4523 -3703 4 15.4791 1.15983 9.85648 -24.9846 -0.242798 0.374642 -3704 4 14.0639 0.416501 9.81608 3.47586 -8.24251 -5.69878 -3705 6 34.4238 40.9137 13.0059 -4.24882 -26.6665 -25.0696 -3706 4 34.0907 40.4301 12.2099 6.6876 25.2293 12.1693 -3707 4 34.3655 40.2093 13.6737 -1.45879 20.9599 -0.365544 -3708 6 42.1372 25.6317 33.9946 32.9644 -29.1434 -4.32848 -3709 4 41.7256 25.3671 33.1599 -4.34041 1.82357 5.58197 -3710 4 42.8775 24.9612 34.1276 -26.6125 21.4128 -4.76888 -3711 6 29.2041 22.5904 40.0709 -12.2401 -3.24737 -11.2113 -3712 4 28.5312 23.0545 39.5673 2.40343 6.95864 -1.48823 -3713 4 29.0042 22.7646 40.9807 1.44808 0.219743 17.343 -3714 6 44.8039 18.6198 1.5029 3.83338 16.5679 14.3409 -3715 4 44.9659 19.0204 2.39019 -3.90529 -17.866 -14.3425 -3716 4 44.0478 19.1074 1.16429 2.25905 3.06151 -3.31671 -3717 6 4.48486 10.8191 23.9456 -47.6019 -35.9978 3.19751 -3718 4 5.13394 11.3869 23.6113 33.8353 31.137 -11.4748 -3719 4 4.52769 10.7271 24.8961 2.68899 9.9192 5.78369 -3720 6 6.46393 23.0191 29.0034 23.802 4.69353 23.6764 -3721 4 7.14249 23.0161 29.7285 -18.6834 17.7038 -21.9419 -3722 4 6.49076 22.0968 28.8008 -10.0115 -22.5628 -12.4771 -3723 6 39.7912 25.1434 32.5739 17.5205 -18.6836 -60.5647 -3724 4 39.6128 25.3468 33.4485 -16.6712 22.7672 53.7369 -3725 4 39.6667 25.9357 32.0325 -1.3786 -0.359445 4.68486 -3726 6 40.844 21.4875 8.87812 10.6958 -1.16061 -24.4784 -3727 4 40.753 21.3778 7.91779 -6.86728 3.07162 8.13114 -3728 4 41.3272 20.6946 9.13123 4.7165 -6.17308 11.2164 -3729 6 0.614957 1.42802 12.9561 35.282 30.4207 -35.1483 -3730 4 54.8795 1.90166 12.5287 -4.84596 -15.7095 11.3484 -3731 4 0.325279 0.716474 13.4972 -22.2917 -16.9379 18.816 -3732 6 32.6687 29.7155 23.4821 0.172893 -14.8348 21.3896 -3733 4 32.2937 28.8037 23.5347 8.27316 18.2339 -7.75927 -3734 4 32.5776 29.9928 22.5742 -5.86304 -0.191283 -15.879 -3735 6 12.5314 37.1515 20.4729 45.6241 64.5302 32.6184 -3736 4 13.0675 37.1561 21.3077 -14.1528 -0.638655 -18.1117 -3737 4 12.0966 36.3476 20.454 -27.4762 -63.6198 -6.10217 -3738 6 13.8924 14.5151 24.69 -3.15938 -4.02598 20.115 -3739 4 13.491 15.2498 24.2338 -4.44789 9.69439 -9.34194 -3740 4 14.0279 14.8194 25.6039 -0.281954 0.872924 -9.09093 -3741 6 17.5021 27.063 26.4741 18.9499 -7.93165 -17.7551 -3742 4 17.3645 27.9616 26.0981 5.20292 -20.1733 2.46217 -3743 4 18.105 26.551 25.8503 -19.0729 23.9469 15.4793 -3744 6 54.4877 9.53021 26.3477 -5.78247 7.96784 25.4661 -3745 4 54.0512 10.3733 26.628 8.34027 -15.1138 -9.49744 -3746 4 54.8923 9.139 27.1544 -8.60221 9.32804 -13.3813 -3747 6 33.6807 21.5011 24.9225 20.8165 12.7411 -37.5161 -3748 4 33.6447 21.5342 23.9109 -0.857654 -11.0597 35.2787 -3749 4 32.8481 21.1477 25.2212 -19.5227 -6.82771 5.56304 -3750 6 22.1475 35.2701 2.885 -1.57378 -2.18642 30.1771 -3751 4 22.1887 34.3602 2.5781 3.09514 -3.18559 -9.19859 -3752 4 22.1072 35.1817 3.87164 0.12039 0.813186 -18.6146 -3753 6 45.3027 5.41438 15.6133 24.4211 -32.124 17.7203 -3754 4 45.2073 5.06649 16.5292 -4.89018 16.6426 -14.7318 -3755 4 44.541 5.92364 15.3615 -17.3903 4.72304 -1.03383 -3756 6 5.67534 7.5869 16.981 -5.47297 6.8358 -20.2139 -3757 4 5.25896 7.81046 16.1225 6.35918 -0.232773 12.9215 -3758 4 6.51331 8.07041 16.9918 4.7107 -6.94883 2.60141 -3759 6 34.576 39.0992 27.2053 24.5889 13.5844 -33.9491 -3760 4 34.3093 38.4547 27.8221 -16.0328 -19.2876 29.327 -3761 4 34.0621 39.904 27.3046 -7.96056 4.01318 13.6593 -3762 6 32.7541 33.6107 34.2903 -12.2088 11.6467 -22.6039 -3763 4 32.1008 34.0277 33.6489 27.9813 -13.6615 23.3944 -3764 4 32.6574 34.0489 35.1447 -11.8345 -0.637226 -0.957772 -3765 6 31.0088 41.2052 32.3952 -16.5884 -4.13679 -5.08533 -3766 4 30.2065 41.1942 32.9317 -1.71273 -1.00977 6.80252 -3767 4 30.9738 0.147898 31.9828 5.47722 15.337 -6.15299 -3768 6 7.65161 1.58314 27.1492 34.9115 -9.04616 -23.8477 -3769 4 8.49581 1.43905 26.61 -35.9655 -7.00487 18.1392 -3770 4 7.51162 2.51613 27.0476 -4.48076 16.5289 1.77021 -3771 6 0.884173 22.0999 37.8474 19.5684 -22.3581 -15.9684 -3772 4 1.29289 21.3236 37.3582 -15.3878 24.821 16.8607 -3773 4 1.19208 22.8872 37.3739 -1.97361 -3.14502 -0.467946 -3774 6 7.41204 11.1157 19.2314 -38.1481 -15.0427 -1.85178 -3775 4 7.53858 12.0593 19.2468 12.5581 17.6457 8.19935 -3776 4 8.2604 10.6916 19.3015 17.9889 5.14781 -4.65775 -3777 6 43.7858 12.4956 37.3097 0.920036 9.73958 -3.1733 -3778 4 43.9612 12.5094 36.3537 -0.436236 -2.21513 6.60981 -3779 4 44.6264 12.7918 37.692 -0.443403 -7.75914 -0.361508 -3780 6 29.0868 33.5248 36.1867 6.33086 18.8505 -43.8567 -3781 4 29.87 33.99 35.8176 -18.9328 -5.41066 10.4629 -3782 4 29.4633 33.0358 36.8874 15.3521 -14.5291 31.9885 -3783 6 14.802 4.59099 3.93345 20.4849 22.8827 12.2406 -3784 4 14.3757 4.0439 3.27797 -5.14737 -6.71868 -8.73832 -3785 4 15.6594 4.91612 3.57855 -16.4986 -14.1515 -5.85747 -3786 6 39.0551 6.39795 6.38864 -31.6963 1.09254 42.8867 -3787 4 39.3692 7.21691 6.04781 17.6944 18.3081 -17.2196 -3788 4 39.3538 5.69048 5.84285 10.6785 -8.50098 -20.4551 -3789 6 22.2123 37.9977 40.776 -14.7699 -23.2033 -28.4168 -3790 4 22.4586 38.8695 40.5021 9.68098 25.7962 -2.3277 -3791 4 22.4791 37.9118 41.6765 7.85923 -2.07179 26.9545 -3792 6 4.44877 23.2867 6.14309 -1.92846 -21.7963 14.7751 -3793 4 3.85981 23.8785 6.59389 -8.34079 22.3777 -5.30491 -3794 4 4.15148 22.4458 6.53602 18.5324 -1.87236 -10.5169 -3795 6 12.4298 23.7885 9.24819 15.5635 1.24594 19.7483 -3796 4 11.6299 23.5219 8.81427 -22.2296 0.449899 -3.14002 -3797 4 12.2156 24.1823 10.1208 2.55292 -1.37139 -18.7826 -3798 6 46.4922 15.2589 16.9667 3.22745 3.94864 2.0367 -3799 4 47.1791 14.9867 16.3488 -1.59454 -10.7105 -10.6804 -3800 4 46.8221 16.1143 17.2497 1.89409 2.98219 12.0057 -3801 6 34.1117 27.1644 19.7797 24.4736 -11.2812 21.2279 -3802 4 34.8774 26.5238 19.7962 -19.6491 14.1094 -6.20677 -3803 4 34.0324 27.4806 20.6991 -2.21978 -4.312 -16.0235 -3804 6 46.9479 13.2121 35.1109 14.7829 18.0264 15.8687 -3805 4 47.3232 14.0654 34.8894 8.1348 3.75559 6.81177 -3806 4 46.5576 12.9943 34.2929 -17.7211 -19.0679 -23.646 -3807 6 50.5883 18.7922 12.536 -4.97475 -8.40096 -18.6689 -3808 4 49.7377 18.4417 12.2063 9.85466 0.19572 8.20723 -3809 4 51.2037 18.6585 11.7837 -7.44169 10.1395 9.07394 -3810 6 32.4871 12.6357 31.9554 3.75694 -28.5712 -45.9238 -3811 4 32.607 11.6542 31.8864 5.47128 21.8321 9.55763 -3812 4 32.4011 12.8494 32.8587 -4.02679 2.16968 41.7104 -3813 6 6.20502 19.6778 10.0162 1.71901 21.9334 16.0314 -3814 4 6.41826 20.2441 9.25697 6.75258 -1.0862 1.44387 -3815 4 6.08129 20.3112 10.7738 2.93045 -16.0896 -19.0741 -3816 6 21.5254 21.5246 2.44441 10.1652 3.23891 -24.6245 -3817 4 21.7373 21.5014 1.49425 -3.90993 5.22039 4.49463 -3818 4 22.0841 20.8004 2.76184 -10.1442 1.98878 12.5692 -3819 6 38.3901 23.0895 17.1987 11.9637 -29.1373 -23.0023 -3820 4 38.7115 23.1739 16.2902 2.30233 23.4463 5.8212 -3821 4 38.6091 22.1461 17.2941 -10.4226 8.48715 23.8901 -3822 6 29.6992 24.9636 22.2212 38.6917 -37.4999 -9.7813 -3823 4 30.2244 25.0209 22.9989 19.9484 -5.9881 25.7874 -3824 4 29.0295 25.5321 22.4534 -63.588 46.0104 6.14599 -3825 6 30.2959 21.4331 37.7732 -36.6703 24.7369 -1.55525 -3826 4 30.3833 21.3736 36.7928 -5.6984 1.01251 23.2154 -3827 4 29.3642 21.7906 38.031 44.833 -25.8334 -23.6526 -3828 6 11.8968 11.712 16.3062 -52.2626 -16.509 -42.1992 -3829 4 11.3487 12.2512 16.8737 -4.04714 4.99791 6.8918 -3830 4 11.2749 11.5458 15.4981 35.5887 6.11969 38.645 -3831 6 5.69762 16.9728 10.4703 1.06122 -0.586779 5.28994 -3832 4 4.99177 17.1708 11.0979 -1.96678 -11.04 -5.71485 -3833 4 5.85288 17.8179 10.0528 3.40155 4.97172 -3.96907 -3834 6 41.7052 34.1635 35.8846 2.77529 22.9845 38.2917 -3835 4 41.9958 35.0267 36.2582 -8.6238 -19.1969 -5.00662 -3836 4 41.6615 34.3005 34.9574 -2.57818 -0.630621 -34.674 -3837 6 33.7668 1.16041 30.1021 -7.73366 -5.3538 60.0773 -3838 4 32.8437 1.27671 30.3431 -6.56672 10.3256 -18.6068 -3839 4 34.0939 1.04339 31.0463 15.1522 -1.22783 -40.312 -3840 6 50.3589 18.6227 36.9888 29.2523 22.0538 -2.88024 -3841 4 50.1022 18.8636 37.8788 -6.7252 3.81489 7.59342 -3842 4 49.7597 17.9698 36.6907 -30.5426 -29.286 -11.4073 -3843 6 24.6818 24.2557 40.239 -30.3362 18.6852 9.52233 -3844 4 23.7683 24.4347 40.5809 21.1328 -2.57181 -5.50386 -3845 4 24.791 23.3075 40.3447 2.5826 -1.14956 -5.51696 -3846 6 37.3025 22.0306 23.2304 -1.24857 -1.55203 26.5345 -3847 4 37.0034 21.8174 24.1364 -3.77965 7.42086 -11.5868 -3848 4 37.7677 21.2337 22.9852 8.84969 -1.31238 -13.2672 -3849 6 48.4163 40.4951 28.9695 -6.68628 11.813 -16.9736 -3850 4 49.0084 41.2243 28.7075 -10.6266 -4.31108 -6.63999 -3851 4 47.6767 40.479 28.3098 12.2088 -0.876211 11.6705 -3852 6 24.8524 8.74511 16.566 -5.47802 -1.24744 16.6444 -3853 4 25.3154 9.32041 17.1898 2.58295 -0.80606 -7.28092 -3854 4 25.3735 7.93816 16.4942 1.51819 -5.71343 -7.74972 -3855 6 19.2312 23.0154 32.4581 7.29767 -10.2486 -2.08042 -3856 4 18.4295 23.4489 32.1618 3.75321 4.57429 -6.83594 -3857 4 18.9208 22.4103 33.1253 1.01223 -4.21105 8.69504 -3858 6 3.33807 21.6805 22.4551 -46.3933 -7.60477 16.0737 -3859 4 2.65604 22.1286 23.0335 23.3212 -20.9163 -13.0515 -3860 4 4.02869 22.318 22.3903 27.1551 13.0827 -5.07429 -3861 6 10.2258 20.3371 12.829 -8.54969 -20.6717 -8.68144 -3862 4 9.56384 20.8338 13.3253 4.28314 2.73019 -3.94148 -3863 4 9.70568 19.6401 12.367 8.3544 15.6282 9.01344 -3864 6 9.53393 0.668964 25.3385 8.23748 17.1946 -9.08311 -3865 4 10.3992 0.538209 25.8183 -20.1327 16.9559 -17.4439 -3866 4 9.57635 1.38514 24.6117 12.9812 -33.3008 29.4344 -3867 6 10.6624 40.712 9.64369 -16.6479 -8.09828 -30.6343 -3868 4 10.6692 41.3905 10.303 1.51816 10.4523 18.0663 -3869 4 9.97599 41.0031 8.99599 12.0328 -9.66263 16.6565 -3870 6 46.359 25.2248 32.6769 -14.7838 37.2607 37.796 -3871 4 46.1367 26.0735 33.2154 13.6855 -48.6436 -31.9122 -3872 4 46.6282 25.5659 31.8216 4.36769 -3.83668 -6.22015 -3873 6 38.9431 3.2028 23.1016 18.0409 -17.6687 24.963 -3874 4 38.0396 3.32435 22.9005 -28.138 13.963 -19.732 -3875 4 38.8834 2.64883 23.9052 13.1186 5.8311 -6.82495 -3876 6 33.334 23.6417 36.8871 -1.6197 -14.346 14.9842 -3877 4 32.7695 23.6175 37.7211 18.6046 10.6207 -30.6843 -3878 4 33.5528 24.5621 36.6745 -4.59115 1.63353 1.59233 -3879 6 51.9355 33.3272 25.435 24.4931 61.1901 -39.0042 -3880 4 51.4286 33.1494 26.1943 -20.5556 -13.8295 37.3068 -3881 4 51.9313 34.3506 25.3627 -2.33157 -52.0679 -5.38276 -3882 6 32.1777 25.0215 33.1655 -4.40266 21.2191 -9.05445 -3883 4 32.7541 25.8194 33.0841 -10.7751 -17.7804 3.95932 -3884 4 31.2703 25.3891 33.0319 13.5135 -10.8842 0.697404 -3885 6 51.2858 27.7149 39.5023 -29.438 -28.7732 26.1015 -3886 4 51.6029 27.7352 38.6212 16.0201 9.86215 -30.6452 -3887 4 51.6337 28.456 39.976 12.6328 17.4546 7.30145 -3888 6 34.2938 28.319 17.2582 8.1769 -6.30709 4.0332 -3889 4 33.5147 28.7567 16.9609 -27.2201 13.5182 -7.119 -3890 4 34.2215 28.3851 18.2119 5.48963 -10.3892 10.8325 -3891 6 36.9125 8.03614 37.8626 31.6258 41.6511 37.5008 -3892 4 37.1772 8.64874 37.1722 -6.23292 -16.4311 -22.0997 -3893 4 37.3691 8.52088 38.6203 -30.9712 -36.3395 -15.9768 -3894 6 34.8794 19.4073 6.12479 12.5531 6.66298 1.29528 -3895 4 34.0931 18.8687 6.15723 -9.84615 -2.81902 0.903663 -3896 4 34.5874 20.3343 6.07707 7.75337 -1.04832 -3.72421 -3897 6 52.9388 9.46792 7.82791 49.0384 32.8563 -49.3294 -3898 4 52.8922 10.1625 7.06425 -6.6048 -31.3865 41.9454 -3899 4 52.145 9.34409 8.30569 -37.6802 7.72308 13.142 -3900 6 36.3078 5.4787 38.9756 -59.3492 -35.3574 -23.3076 -3901 4 36.7604 5.44249 39.7856 34.2456 7.44664 27.0781 -3902 4 36.4713 6.28646 38.5283 19.3627 32.146 -13.2298 -3903 6 10.0102 14.4476 13.47 7.45507 32.9986 11.9551 -3904 4 10.2267 15.3574 13.7991 -6.33005 -21.0964 -5.42394 -3905 4 9.26267 14.5991 12.8847 -7.70629 -5.78085 -0.713961 -3906 6 17.2158 24.3617 39.7859 1.82925 -26.4802 17.5225 -3907 4 16.9252 25.2477 39.6578 -10.2532 23.1813 -8.78866 -3908 4 16.8659 24.1409 40.6742 12.3143 -2.49802 -8.33055 -3909 6 49.0708 32.5605 7.76617 4.98775 -19.9892 12.4117 -3910 4 48.2488 33.0406 7.85919 -4.66971 4.38963 1.84033 -3911 4 49.5854 32.9586 7.08254 9.03816 10.9607 -18.1455 -3912 6 44.8772 24.3958 5.47001 55.4245 15.4507 -4.26518 -3913 4 44.8128 24.5742 6.41303 -16.1158 -0.171295 7.10823 -3914 4 44.0866 23.9971 5.17679 -42.0653 -18.1716 -4.3799 -3915 6 37.3106 29.1913 32.8596 13.2918 -7.82588 25.4298 -3916 4 36.7195 29.353 33.61 10.148 2.43022 -0.346483 -3917 4 36.7915 29.3572 32.1043 -27.5405 3.64351 -29.7293 -3918 6 0.903259 24.8209 21.2384 21.1637 23.8586 -12.5999 -3919 4 1.07153 25.1845 20.3306 -6.36458 -4.90686 24.2304 -3920 4 1.48599 25.3539 21.839 -15.2813 -16.355 -7.82064 -3921 6 53.0335 2.20305 13.0061 -8.76459 0.917863 -30.1717 -3922 4 52.7178 1.83592 13.8181 -1.16689 -4.66991 20.3458 -3923 4 53.3973 3.07458 13.1779 4.70755 1.41814 13.7418 -3924 6 24.3073 33.9788 13.9425 26.9643 -19.8352 3.53447 -3925 4 23.8166 33.1535 14.1304 2.48225 11.7572 -2.64876 -3926 4 25.2622 33.8278 14.204 -36.1259 9.29052 -3.07765 -3927 6 40.931 19.3008 0.314297 -22.2267 40.7784 4.53314 -3928 4 41.073 18.3876 0.266006 15.5735 -49.6404 -1.39225 -3929 4 41.7685 19.7545 0.415523 11.1161 2.19254 -0.550631 -3930 6 38.3131 32.0321 21.5909 -11.558 27.6654 -12.3629 -3931 4 37.7152 31.3901 21.181 3.54948 -0.803384 -4.61225 -3932 4 38.0485 32.9451 21.2634 6.02672 -33.9485 15.0266 -3933 6 42.3093 34.9988 16.9782 -31.0886 21.3467 -4.04435 -3934 4 41.4322 34.9872 17.4259 23.1708 5.16072 -1.2535 -3935 4 42.7209 34.172 17.1456 10.0707 -23.8474 2.85212 -3936 6 19.5555 24.3301 21.9337 4.81064 -45.312 41.7565 -3937 4 19.0503 23.5208 22.2695 18.6897 32.4519 -16.5084 -3938 4 18.9494 24.7901 21.383 -21.2783 9.24005 -16.3011 -3939 6 21.0765 3.08453 14.9497 18.8565 6.62045 0.482113 -3940 4 21.9827 3.42458 15.1377 -20.4059 -2.71097 -2.70114 -3941 4 21.0593 2.94323 13.9894 -7.00518 -5.35814 1.95693 -3942 6 16.4422 12.1477 28.531 -0.750899 4.00912 3.87665 -3943 4 16.9503 12.6102 29.2147 -1.62139 -0.392447 -5.94721 -3944 4 15.8278 12.7952 28.1633 1.40376 -4.03425 1.22377 -3945 6 29.5501 4.7113 21.752 31.6763 -19.7408 -11.7502 -3946 4 29.7575 3.81476 21.3864 -8.62397 20.1371 9.94028 -3947 4 28.6767 4.97136 21.4837 -14.307 1.15287 -5.34284 -3948 6 47.4015 12.0887 13.4082 -20.234 -20.0739 19.2385 -3949 4 46.7896 12.1748 12.658 5.24956 2.33261 8.08179 -3950 4 46.8763 11.6307 14.143 25.8489 23.9178 -32.3489 -3951 6 26.4368 0.034911 5.58657 -64.7941 -10.5287 17.818 -3952 4 25.4579 0.386547 5.64311 57.7785 -5.53424 -8.5606 -3953 4 26.2825 41.0177 5.90114 11.1228 18.2746 -10.9356 -3954 6 20.8239 34.8091 41.3451 3.02448 22.7042 23.7072 -3955 4 20.8848 35.7307 41.7064 -1.83719 -23.2001 -12.5561 -3956 4 21.5135 34.3024 41.8142 -0.435548 5.34794 -5.15218 -3957 6 12.6914 17.4806 1.38079 -1.22179 11.8948 19.0955 -3958 4 12.6924 17.2614 2.32235 1.20892 0.120609 -3.36771 -3959 4 12.6119 16.652 0.923905 -0.609755 -13.5185 -16.0456 -3960 6 30.0783 10.198 8.41195 2.12134 -1.25171 -25.3141 -3961 4 29.3533 10.7626 8.0964 5.01977 -3.23694 0.534487 -3962 4 29.9182 10.0601 9.33268 -3.94599 -2.47727 24.1034 -3963 6 36.3506 5.44781 23.9083 -0.549638 14.3818 20.7021 -3964 4 36.0156 6.32048 23.6328 6.62881 -2.58855 0.476976 -3965 4 37.0027 5.63115 24.6267 -8.58297 -8.41851 -13.9364 -3966 6 34.0301 39.9488 19.4964 -23.0399 -20.8249 18.5921 -3967 4 34.456 39.4415 20.2152 6.93565 15.6495 -14.2212 -3968 4 34.6348 40.5483 19.0534 11.5364 2.12704 2.14354 -3969 6 25.0981 29.0133 17.0022 63.4673 53.603 -24.6749 -3970 4 24.4066 28.4545 17.2066 -49.3728 -47.1307 14.2315 -3971 4 24.9323 29.3693 16.11 -4.01222 -10.2038 10.3173 -3972 6 28.4991 21.3215 6.5284 30.3134 51.3135 12.4116 -3973 4 28.073 21.8131 5.82363 -12.0684 -17.0718 -17.6117 -3974 4 29.0439 22.0969 6.88435 -18.1485 -38.7813 5.23359 -3975 6 18.6639 26.1486 0.434559 17.278 41.4043 -10.2832 -3976 4 18.2934 25.3073 0.618971 -26.4426 -25.2614 5.85754 -3977 4 18.1648 26.8598 0.892557 2.28699 -17.4047 3.2853 -3978 6 10.9881 29.7025 15.4563 -76.0882 18.6105 19.9394 -3979 4 11.66 29.3744 14.945 58.6215 -25.2203 -34.7363 -3980 4 11.3165 30.0451 16.2682 18.0847 5.23212 20.5617 -3981 6 33.4842 3.75768 10.5858 0.636803 10.5574 28.6939 -3982 4 33.4734 3.50079 11.5612 -0.522502 1.02567 -36.066 -3983 4 33.5593 4.73652 10.6 -0.068286 -14.4363 0.33475 -3984 6 12.2823 28.8038 23.0281 11.3775 -6.29424 6.84391 -3985 4 12.7596 29.6284 22.9364 3.04418 8.52871 -1.54448 -3986 4 11.6562 28.9633 23.7417 -11.9653 1.92572 -6.97409 -3987 6 13.0879 10.2853 41.0171 -47.2786 6.02767 7.69694 -3988 4 13.8008 10.0588 41.5617 38.8858 -12.6991 24.323 -3989 4 13.445 10.533 40.1929 12.5253 9.31307 -31.237 -3990 6 45.8279 29.9763 22.3517 -19.0059 -47.3471 -0.794771 -3991 4 46.3385 30.6632 22.7121 22.9496 35.5749 11.5915 -3992 4 46.1736 29.1608 22.8005 -10.4716 15.4455 -15.9284 -3993 6 41.5587 12.1258 14.79 16.8952 2.46742 -19.497 -3994 4 40.8127 12.0778 15.3866 -8.88903 2.06539 11.4921 -3995 4 41.9001 13.025 14.8368 0.886253 5.83282 4.44761 -3996 6 18.1774 7.21532 24.17 -10.7079 71.0597 15.5191 -3997 4 17.3895 7.85304 24.2309 32.278 -29.8877 -8.26822 -3998 4 17.8432 6.3671 24.0218 -31.5603 -50.1252 -1.23769 -3999 6 1.46617 28.3087 7.5822 17.4051 32.8243 -18.4272 -4000 4 0.972435 27.5241 7.77639 -23.983 -7.56132 -3.64975 -4001 4 0.919057 29.0368 7.16413 8.17263 -22.6878 11.3207 -4002 6 11.3257 12.3178 24.0505 6.50608 36.5044 21.7543 -4003 4 11.787 12.9182 24.6663 -15.142 9.53056 -9.69028 -4004 4 11.7144 11.5384 24.3755 9.90684 -45.3393 2.97811 -4005 6 17.9727 40.4585 24.4268 -2.1753 13.4943 43.6914 -4006 4 18.2079 40.9973 23.706 15.3173 17.1897 -35.5256 -4007 4 17.8423 41.1404 25.131 2.16294 -27.9915 -10.5346 -4008 6 25.5983 7.44259 34.0136 19.3716 5.77393 -21.6373 -4009 4 25.8935 7.97324 33.2232 -7.88236 -13.8451 20.6491 -4010 4 24.6626 7.5793 34.1612 -12.3217 5.75259 0.6842 -4011 6 16.9533 36.3934 7.79695 -14.7733 -58.972 -15.2131 -4012 4 16.1509 35.7821 7.92089 32.5681 38.8119 0.0631702 -4013 4 16.873 37.2333 8.21975 -10.866 19.0251 14.3825 -4014 6 12.4478 39.1676 36.8063 -58.2746 -19.2691 -7.14825 -4015 4 13.2621 39.5728 37.0444 24.763 -2.90148 -1.94315 -4016 4 12.5678 38.2718 36.42 14.2903 21.5885 11.3364 -4017 6 23.4428 1.91286 37.7232 -9.22102 6.32267 -24.8838 -4018 4 22.7837 1.60923 37.0782 3.11058 2.78987 13.6287 -4019 4 23.6923 2.7833 37.361 6.97145 -2.92816 9.87668 -4020 6 26.6131 34.8527 39.0629 -0.358317 22.46 -5.08852 -4021 4 25.9211 35.0251 39.7209 4.63868 -0.642547 -8.45736 -4022 4 26.6245 35.623 38.4346 -11.8568 -25.3624 13.8384 -4023 6 44.7506 35.5772 23.1679 10.7298 -18.8811 -26.4233 -4024 4 44.6498 36.2622 23.8111 -7.39072 22.4611 10.5052 -4025 4 44.899 35.9413 22.2637 -2.27133 -5.1907 16.9936 -4026 6 34.6136 35.4178 26.71 -15.9342 1.46423 13.2724 -4027 4 33.7739 35.201 27.1682 15.3038 9.13482 -13.5788 -4028 4 35.2424 35.4667 27.4557 -1.55634 5.60609 -12.3698 -4029 6 12.4253 29.8367 9.37257 6.8074 7.71813 14.8361 -4030 4 12.5954 30.1793 10.279 -1.64518 -2.79843 -17.3301 -4031 4 11.9756 30.5342 8.87466 -2.55144 0.413422 5.70549 -4032 6 46.4578 41.3781 16.9525 -1.71223 -15.9012 -6.63524 -4033 4 46.309 0.164546 17.5847 2.66821 13.6546 8.2853 -4034 4 46.3887 41.8168 16.0911 -0.805017 -2.71613 2.08401 -4035 6 39.1753 31.0467 24.0118 -3.10819 6.08124 -21.6124 -4036 4 39.1065 31.2708 23.0301 -7.23524 -5.82233 36.9271 -4037 4 38.2867 31.0608 24.4123 9.52041 3.88051 -10.8568 -4038 6 40.5402 9.7597 28.9847 14.8037 -28.2595 -25.194 -4039 4 40.7176 8.78836 28.9335 -4.00485 22.4893 3.39032 -4040 4 39.9733 9.89103 29.7293 -9.65138 5.58475 19.0645 -4041 6 33.5593 11.9211 22.729 -1.15717 -3.69298 36.7387 -4042 4 33.4631 12.1387 21.8005 -14.8881 8.7456 -3.74916 -4043 4 32.9393 12.4796 23.2922 26.8098 -15.4098 -27.756 -4044 6 29.0159 38.7519 2.46278 27.6721 -15.5988 -40.3681 -4045 4 29.1586 39.6546 2.1748 2.74048 3.67355 2.54153 -4046 4 28.5501 38.8453 3.26351 -22.211 -0.421087 25.3577 -4047 6 51.2833 6.14739 28.3043 6.24107 -1.78447 -16.8419 -4048 4 51.6927 5.30788 28.0231 -4.79213 3.01935 13.8596 -4049 4 51.5671 6.73798 27.5888 -1.89698 -2.53529 10.4249 -4050 6 34.1064 16.6123 14.042 -37.0155 -16.4066 -7.07731 -4051 4 33.9904 17.5439 13.9588 -10.6946 23.5239 -0.125603 -4052 4 35.0244 16.4872 14.0391 48.662 -2.86898 -0.118382 -4053 6 34.4321 40.0645 7.48859 13.9518 5.57425 38.6209 -4054 4 34.6497 40.8416 6.93548 -15.3832 -25.9537 -5.407 -4055 4 34.0868 39.3056 7.01264 2.49953 7.17747 -18.8692 -4056 6 42.5297 22.9808 4.38266 2.56422 12.7755 -29.8183 -4057 4 42.7079 23.1404 3.43503 2.07895 -8.20356 9.72626 -4058 4 41.6007 23.2438 4.43282 3.68115 -1.88729 13.9368 -4059 6 1.41725 11.7089 10.583 40.9585 72.4956 7.82458 -4060 4 2.29602 11.7947 10.1149 -31.3121 -19.1762 2.07637 -4061 4 1.32217 12.6809 10.8959 0.250133 -47.8987 -12.0904 -4062 6 10.0222 17.1523 40.4009 -13.9984 -42.4532 23.0969 -4063 4 9.09922 16.7881 40.4362 25.3227 17.9847 -3.64852 -4064 4 10.5566 16.4623 40.9043 -11.7978 28.1532 -20.1855 -4065 6 26.3773 1.16785 23.7951 0.897687 17.1036 -20.4546 -4066 4 26.2949 1.59753 22.8926 6.72339 -10.2637 31.134 -4067 4 26.8106 1.83522 24.3632 0.404944 -5.36666 -8.232 -4068 6 4.47728 16.2319 39.0174 38.9165 -19.7518 -18.3291 -4069 4 4.60126 15.8787 38.0926 -3.95383 11.2541 23.7603 -4070 4 5.37849 16.1152 39.4714 -36.6531 9.54225 -13.0705 -4071 6 24.3645 39.8454 14.0862 11.6717 18.512 -7.42816 -4072 4 24.2179 40.7168 13.6655 -1.51261 -13.0973 5.973 -4073 4 25.144 39.5095 13.6466 2.38152 -7.3908 -1.6645 -4074 6 19.9724 19.004 10.1294 8.87966 -14.5095 2.71373 -4075 4 19.0999 19.3915 10.2782 -1.93643 -3.06257 7.63815 -4076 4 20.1403 18.2899 10.8137 -9.49435 28.7308 -18.8504 -4077 6 45.2455 15.0555 25.2985 9.44949 25.5865 29.6023 -4078 4 44.5225 15.6147 25.6238 -9.11717 -2.3226 -13.4673 -4079 4 44.9162 14.4027 24.6993 -17.0358 -18.2103 -14.0354 -4080 6 47.6513 32.9537 29.9733 -3.02769 -8.48031 15.1317 -4081 4 47.7848 32.4488 30.7976 5.01558 10.2706 -8.76515 -4082 4 46.6987 33.0693 29.9097 -5.02316 -0.316015 -4.02449 -4083 6 9.31033 14.1561 35.6305 -9.15199 13.4931 14.7277 -4084 4 10.2186 13.9515 35.3646 1.69372 -1.68405 10.862 -4085 4 9.25805 14.5533 36.5394 11.2175 -11.577 -22.5615 -4086 6 0.560208 28.7354 32.128 -23.2584 38.0618 20.8665 -4087 4 0.439761 29.1616 31.2639 2.79308 -8.58991 0.800302 -4088 4 0.67028 27.8063 31.9961 10.5465 -16.7679 -9.91325 -4089 6 26.1282 14.1993 40.8411 59.6454 -38.6249 5.43898 -4090 4 26.432 13.4524 41.4491 -20.3805 31.5142 -12.0858 -4091 4 25.201 14.2926 40.8644 -35.6636 2.31432 7.08225 -4092 6 38.0409 1.72795 37.3461 -15.986 9.3487 3.27435 -4093 4 38.337 1.77003 36.4219 -6.4212 0.733726 8.60438 -4094 4 37.1869 2.24333 37.3721 25.3175 -16.9011 -0.126137 -4095 6 43.391 21.0055 0.385428 11.1435 51.3868 10.1231 -4096 4 43.3728 21.9356 0.739051 -22.7765 -27.5137 5.23027 -4097 4 44.2566 21.1078 41.893 4.66373 -25.0138 -11.6612 -4098 6 29.7339 12.3948 17.084 15.7249 11.0657 13.1734 -4099 4 30.3928 12.9555 17.5239 -4.04604 16.1495 -27.1654 -4100 4 29.6387 11.801 17.8166 -19.321 -23.8097 4.84602 -4101 6 21.0831 10.9976 35.6454 20.8751 25.9078 26.8503 -4102 4 20.9144 11.9356 35.5 -2.5465 -0.914036 2.40284 -4103 4 20.6111 10.5739 34.9651 -17.7649 -25.2648 -31.6786 -4104 6 24.3635 22.1336 17.0651 -49.7832 5.03398 -16.9936 -4105 4 24.7447 22.8357 16.5516 14.0354 11.6369 -2.31656 -4106 4 25.0369 21.6158 17.4366 35.7007 -17.2122 18.4164 -4107 6 44.2543 9.63808 6.15039 20.313 -11.2139 14.5913 -4108 4 44.7688 9.46356 5.36091 -1.47318 -0.699349 -10.0319 -4109 4 43.371 9.9028 5.92157 -14.9065 6.10764 -5.2575 -4110 6 40.8032 2.87739 6.28666 -13.1289 22.479 10.901 -4111 4 40.3272 3.11809 7.09229 2.74106 -9.45257 -1.64817 -4112 4 40.5645 3.60702 5.69531 8.12536 -6.41414 -12.3146 -4113 6 23.4888 29.7691 25.1996 -20.8577 -7.3866 7.78845 -4114 4 23.0356 30.0691 24.4173 -11.1707 -5.96106 -7.76576 -4115 4 24.1981 30.3761 25.2406 38.2449 14.7306 0.541559 -4116 6 45.2336 20.6129 7.48752 -14.5833 -17.9538 -3.88696 -4117 4 44.4222 20.5961 6.94177 10.1673 3.83834 -0.615812 -4118 4 45.4226 19.6724 7.65027 4.1577 11.2609 0.378107 -4119 6 44.1804 26.5848 16.646 -7.77871 8.0927 60.0057 -4120 4 44.4497 26.5291 15.7549 9.82788 -17.3929 -39.3829 -4121 4 43.995 25.6977 17.0036 0.668911 -2.30329 -14.751 -4122 6 23.5902 27.0659 18.0913 -39.7013 -11.93 7.95298 -4123 4 23.083 26.2674 17.8176 19.208 11.4009 -9.44785 -4124 4 22.9184 27.4761 18.6801 25.6051 0.00742342 -8.40738 -4125 6 45.1467 16.0991 8.91755 -25.3782 -1.90264 -8.59791 -4126 4 44.1891 15.9425 8.7462 16.1978 6.4454 1.17339 -4127 4 45.2138 16.0078 9.87006 7.52298 -2.6657 10.2407 -4128 6 39.0203 15.1531 5.23259 28.6956 12.0263 -26.8074 -4129 4 39.7994 15.5772 4.7964 -10.087 -12.1112 6.39319 -4130 4 38.3368 15.7917 5.08662 -19.5574 10.6606 0.980846 -4131 6 40.468 4.77411 20.0927 -27.3359 -4.798 12.1592 -4132 4 41.2634 4.72652 19.6 29.6653 -1.38796 -18.2664 -4133 4 40.7147 5.23292 20.8909 -0.487482 4.30709 11.6637 -4134 6 35.8395 28.4372 39.9091 -50.8572 -25.335 -8.14583 -4135 4 35.0416 27.8127 39.7761 37.8149 25.8469 12.2999 -4136 4 36.4241 28.1912 39.1903 12.774 -11.5781 0.139918 -4137 6 26.5706 3.57143 2.67715 -46.9093 11.529 -12.2012 -4138 4 26.01 3.47498 1.86726 21.0232 -0.263485 19.1529 -4139 4 25.9795 4.13239 3.25499 25.5536 -16.3527 -3.3314 -4140 6 2.96374 21.6426 17.6806 -14.2306 -5.51577 -4.68338 -4141 4 2.93927 22.2072 18.4518 0.989431 6.72084 9.51867 -4142 4 3.70489 21.9005 17.1296 5.59779 10.8847 0.849605 -4143 6 12.8869 25.0552 25.9401 15.4127 26.4598 -14.83 -4144 4 13.2774 25.9118 25.6194 -5.06291 -21.1213 8.866 -4145 4 12.0842 24.9634 25.4247 -11.7493 -3.09829 -2.0396 -4146 6 41.5869 20.6707 14.1801 -22.4147 -6.05744 0.611169 -4147 4 42.2929 20.1295 13.8255 12.8925 2.43785 -7.39699 -4148 4 41.9118 21.5622 14.3536 8.70683 -8.7017 2.36606 -4149 6 1.26372 39.5934 11.5416 -2.31472 -23.2994 -17.666 -4150 4 1.60499 38.7626 11.0579 -12.721 36.8399 30.164 -4151 4 1.30151 39.4907 12.5143 8.15813 -4.07121 -11.1907 -4152 6 16.0274 39.0089 34.0759 -23.376 3.35378 -54.2756 -4153 4 15.5279 38.2654 33.6809 12.2329 5.59336 21.1278 -4154 4 15.9645 39.6681 33.3256 8.94624 -4.65522 31.8649 -4155 6 20.5749 7.01511 25.5545 -9.93748 22.9073 -1.77669 -4156 4 20.7998 7.9126 25.2373 7.69672 -13.5438 0.480138 -4157 4 19.6147 7.02086 25.4453 1.79337 -5.45304 -5.32881 -4158 6 45.1903 25.5946 39.1745 -26.3826 2.10768 23.1727 -4159 4 45.9078 26.0337 38.7511 23.0136 15.7961 -19.2282 -4160 4 45.315 24.6755 38.9972 4.74877 -22.0383 -3.82349 -4161 6 19.9254 40.1108 28.2935 0.936604 13.13 -6.83142 -4162 4 19.0415 40.3022 27.9603 -1.00367 -13.9734 -0.221352 -4163 4 20.1058 40.9072 28.8104 6.81084 -8.28794 7.10232 -4164 6 26.5025 14.2024 27.3816 7.55525 -11.5245 -39.7478 -4165 4 25.5661 14.1885 27.2241 -23.3405 -0.187867 -1.3667 -4166 4 26.5864 14.6167 28.2174 4.05242 7.69107 36.9512 -4167 6 51.349 25.9455 3.44193 13.1564 1.83251 -14.1309 -4168 4 51.0731 25.276 4.04973 -8.84751 -13.2679 15.0063 -4169 4 51.8098 25.4164 2.75525 -2.9574 19.5765 2.79729 -4170 6 20.1579 26.1269 2.66057 8.08543 -14.232 12.5138 -4171 4 20.4198 25.2285 2.95049 1.99012 13.1431 -7.88687 -4172 4 19.9848 26.1042 1.70984 -1.68704 0.137755 2.48294 -4173 6 3.12857 11.9594 27.2244 18.8731 20.7243 14.7894 -4174 4 2.60719 12.6622 26.8077 5.30838 -2.59233 -3.81502 -4175 4 3.76928 12.4285 27.8301 -19.9135 -11.7573 -12.7739 -4176 6 30.1745 26.3671 4.00755 44.117 -33.7612 35.926 -4177 4 30.7719 25.91 3.40695 8.20711 -11.5121 5.52432 -4178 4 29.6741 26.8182 3.4039 -49.0538 48.0497 -39.0484 -4179 6 19.309 20.6617 30.5327 -6.17305 20.3286 19.7257 -4180 4 19.3357 21.5037 31.0044 -16.2324 -1.53368 2.5841 -4181 4 20.215 20.6027 30.2783 24.1248 -10.9268 -16.9107 -4182 6 13.5428 36.2605 0.333332 15.0011 -10.6689 28.2547 -4183 4 13.9636 37.1467 0.274336 -13.564 -9.3403 -16.0521 -4184 4 12.8146 36.0991 41.6409 -4.77188 14.7057 -15.3617 -4185 6 13.69 21.7667 35.9665 -20.2473 -15.4187 -13.4538 -4186 4 13.4364 21.3658 35.099 7.7487 10.4825 13.8843 -4187 4 14.5406 22.1631 35.8296 17.4857 6.37333 -3.13554 -4188 6 39.4374 1.76506 25.3393 -36.4427 -7.29022 -10.5984 -4189 4 39.9364 2.34528 25.9215 16.7605 -3.08023 1.72977 -4190 4 39.8192 0.8892 25.1573 19.013 15.1682 11.727 -4191 6 18.3049 6.14326 35.8392 -10.8025 -19.5812 3.54688 -4192 4 18.125 5.32611 36.3393 4.50778 0.182671 -16.8727 -4193 4 18.2664 6.78418 36.55 10.3297 13.4079 -7.40032 -4194 6 2.50698 24.635 10.1008 2.82606 57.1639 14.1456 -4195 4 3.34783 24.2504 10.0645 38.9609 -42.7111 -6.9151 -4196 4 2.85647 25.509 10.4424 -34.1939 -15.4438 -5.60802 -4197 6 35.8245 9.94707 1.36321 12.392 22.5458 6.51215 -4198 4 36.2598 10.3662 0.602857 -1.03193 -1.33218 7.37913 -4199 4 36.14 10.4815 2.15194 -8.91958 -29.9524 -28.0328 -4200 6 29.0093 17.9332 41.5934 -7.9582 -11.0366 0.585828 -4201 4 28.5465 17.2289 41.1281 -16.7755 -3.81322 9.83818 -4202 4 29.6221 18.1453 40.9114 24.9254 25.1746 -10.164 -4203 6 46.0106 27.0842 25.8657 -15.8538 -10.6571 1.20957 -4204 4 46.7573 26.8966 26.4316 13.3887 1.52966 8.34957 -4205 4 45.3967 26.3449 26.0537 1.02353 6.85943 -7.5889 -4206 6 28.1115 10.6516 35.9124 -31.4415 -9.81676 -35.067 -4207 4 27.3321 11.0804 35.4953 10.9044 -14.8673 0.927998 -4208 4 28.4149 11.3158 36.4913 19.5717 24.3857 28.0975 -4209 6 25.9462 20.1874 24.7713 21.0981 19.7274 8.06252 -4210 4 26.7479 20.7296 24.6265 -12.3387 -9.71047 -3.27099 -4211 4 25.8934 20.1715 25.7373 -11.4252 -1.9185 3.65337 -4212 6 32.2315 30.2636 10.2038 46.2181 -42.2335 3.06511 -4213 4 32.6954 30.7903 9.55855 -13.4496 21.2522 -10.6663 -4214 4 32.9512 29.5744 10.3289 -28.7668 14.232 9.31608 -4215 6 5.05112 34.4033 23.8133 19.5013 -14.7597 17.0713 -4216 4 5.8904 34.9145 23.8209 -18.4686 -4.57798 -7.44977 -4217 4 4.4328 34.8283 23.2333 -4.78059 12.4432 -11.9709 -4218 6 29.6287 34.9421 23.1129 15.2461 20.4143 1.29823 -4219 4 30.2662 35.203 23.7945 -9.70178 1.77141 2.28452 -4220 4 29.7307 34.0083 23.0447 -4.13429 -24.1479 2.03513 -4221 6 52.1909 25.2296 36.2512 2.86438 -10.6824 22.6831 -4222 4 51.9483 25.3775 37.2028 5.23419 -4.07811 -26.4725 -4223 4 52.3343 24.2634 36.1804 -4.32722 6.81431 1.64545 -4224 6 6.96184 41.26 14.9825 2.80521 -5.8094 -40.534 -4225 4 7.04984 41.0874 15.8994 5.94782 -9.0625 22.8431 -4226 4 7.58542 40.6644 14.4953 -8.6815 16.2518 18.3581 -4227 6 27.6618 39.1341 4.65497 -15.321 -2.42325 19.5764 -4228 4 26.8583 38.6531 4.9607 13.8024 7.31782 -7.34321 -4229 4 28.2878 39.16 5.39008 -5.06496 -7.53921 2.22048 -4230 6 44.4448 15.8874 30.3939 -2.31018 0.103575 -22.4191 -4231 4 43.6353 16.4379 30.2788 15.6665 -12.4266 1.42045 -4232 4 44.7559 15.574 29.5018 -16.8402 11.4423 19.721 -4233 6 27.2939 38.1254 13.0955 15.3768 -40.6351 2.35664 -4234 4 27.6299 37.3572 12.5713 -6.06373 15.2601 5.99839 -4235 4 27.2975 37.7701 14.0147 -10.0522 11.5876 -10.9657 -4236 6 26.6773 32.9794 36.8294 -32.6396 -25.4624 12.1292 -4237 4 27.3491 33.5429 36.5103 30.2383 22.5556 -9.12925 -4238 4 26.1784 33.4868 37.4729 2.39424 7.35453 7.52648 -4239 6 26.3034 28.2003 31.7109 71.1077 16.3155 0.283388 -4240 4 26.8193 28.3341 30.863 -27.929 -6.55919 23.3278 -4241 4 26.9955 28.4613 32.4053 -35.143 -9.24619 -18.2719 -4242 6 49.2075 35.7729 23.3324 -21.4287 30.6035 9.89313 -4243 4 49.7648 36.3085 23.9054 5.92838 -6.84736 -0.0129328 -4244 4 49.7125 35.0813 22.9401 23.5965 -22.3057 -11.2126 -4245 6 44.2384 15.3735 33.5479 -0.546939 -12.4927 -0.897907 -4246 4 44.8734 15.133 32.8785 13.8917 -2.34347 -2.72297 -4247 4 43.5631 15.8174 33.0372 -7.79828 14.1806 -0.143619 -4248 6 16.6415 35.2629 14.0425 -13.711 -12.7272 -22.5016 -4249 4 16.8779 36.1297 14.3524 2.35153 17.3801 14.4176 -4250 4 15.7232 35.3535 13.695 18.4875 1.24889 7.88518 -4251 6 45.2979 21.4768 12.0753 -61.6802 -17.7786 9.36854 -4252 4 45.9745 21.1118 11.5746 47.2025 -15.5682 -31.9287 -4253 4 44.6407 20.7302 12.0307 13.4445 30.1014 15.4365 -4254 6 51.647 5.33893 20.0992 17.3373 6.85256 40.4731 -4255 4 51.8423 5.82757 20.9547 -12.0569 -16.4938 -26.4666 -4256 4 50.8652 5.75336 19.736 -8.70547 10.2387 -6.49138 -4257 6 22.616 27.3068 0.953729 -12.5585 5.72419 11.7926 -4258 4 21.9912 27.9206 1.39427 2.62886 -13.0847 -9.82719 -4259 4 22.9744 27.8285 0.229956 6.91293 3.08187 -2.36887 -4260 6 46.8924 12.1405 22.3241 28.0037 10.4006 6.07885 -4261 4 46.5361 12.6234 21.5839 -13.5229 3.11861 -11.9828 -4262 4 46.2058 11.655 22.757 -25.8682 -9.85748 8.02404 -4263 6 33.7577 5.61095 25.2306 8.81298 -10.6825 9.18366 -4264 4 34.4045 5.06092 24.7535 -5.77276 6.31779 -0.0821136 -4265 4 33.06 5.8369 24.6155 -4.37455 2.20678 -7.03208 -4266 6 44.2424 18.1337 27.2287 35.5912 4.17402 -1.61274 -4267 4 44.1428 18.6708 26.4104 -1.15401 -3.8952 20.8354 -4268 4 45.2041 18.2132 27.495 -32.4507 -0.562547 -10.2772 -4269 6 5.27745 36.9951 29.0779 -48.9341 45.2857 -18.2185 -4270 4 4.83797 37.847 28.7 19.7525 -41.2711 21.6555 -4271 4 6.18662 37.2124 29.1987 31.023 4.60304 7.81739 -4272 6 20.0415 5.02171 38.9415 13.5567 -45.1901 -20.6947 -4273 4 19.673 5.46942 39.6755 -5.65499 20.9205 26.8401 -4274 4 20.3443 4.13258 39.2728 -11.021 23.424 -4.53385 -4275 6 17.9077 2.77821 33.872 -28.7289 7.66476 22.1934 -4276 4 18.5675 3.36618 33.4993 11.2764 5.36232 -3.32863 -4277 4 17.289 3.30252 34.4687 25.3234 -20.0176 -17.8345 -4278 6 5.56252 23.3664 22.3199 23.4646 34.0494 22.6536 -4279 4 6.31266 23.4141 21.6995 -10.6272 -11.1368 -5.13028 -4280 4 5.83055 24.0852 22.9498 -18.4748 -15.0058 -11.9197 -4281 6 12.7366 28.0136 40.0786 16.9267 17.0007 -14.1953 -4282 4 12.7736 28.981 40.2539 2.04889 -13.1204 -10.7842 -4283 4 13.1752 27.8683 39.2015 -12.0592 5.90979 20.7524 -4284 6 50.5208 38.8121 28.4283 -2.96204 -29.3557 2.62021 -4285 4 51.1161 39.4306 28.008 -0.383593 20.3423 -2.32338 -4286 4 49.7133 39.2143 28.7877 7.69194 10.1621 -6.76025 -4287 6 33.551 8.21903 17.8634 -36.1599 -47.4859 45.2019 -4288 4 33.9333 8.85376 17.3385 32.2471 57.3944 -47.1321 -4289 4 33.8604 7.38657 17.5128 5.83122 -9.97324 -0.737685 -4290 6 34.648 34.7105 17.7828 9.01761 -19.7832 -8.77749 -4291 4 35.1788 35.3328 18.2888 -3.00831 8.66808 4.62333 -4292 4 35.2883 34.0014 17.5711 -12.5093 2.94991 -0.39307 -4293 6 40.7261 5.27864 23.3991 8.21105 0.19251 11.4926 -4294 4 41.4259 4.93717 23.9966 -11.2767 2.88733 -17.4667 -4295 4 40.0598 4.58084 23.2941 1.87831 5.06613 5.43463 -4296 6 16.9137 27.769 14.4809 73.6258 -34.7175 -8.82476 -4297 4 16.0667 28.1115 14.4612 -62.8462 32.6704 -2.60496 -4298 4 17.5486 28.5101 14.4313 -15.9271 -1.25076 7.8547 -4299 6 29.0219 14.6595 5.00786 20.8741 -13.5443 13.1138 -4300 4 29.536 13.8229 4.89138 -12.0375 16.0826 3.98067 -4301 4 28.8859 14.7576 5.97494 -2.91261 0.0620574 -16.4413 -4302 6 36.854 17.7325 5.08016 4.48522 -18.3735 -43.8449 -4303 4 36.2168 18.3553 5.39001 -11.7806 18.6728 17.0618 -4304 4 36.8305 17.8608 4.09391 11.7548 -5.76061 25.8999 -4305 6 27.7142 25.5094 34.8662 20.7401 -29.3529 -12.6468 -4306 4 28.3997 25.1535 35.4786 -13.7878 13.2187 -9.69645 -4307 4 27.3728 26.292 35.2699 -5.77421 14.8272 18.3022 -4308 6 24.7481 17.2805 18.0642 -3.31447 -10.4308 -2.46491 -4309 4 25.3087 17.9154 18.5049 2.27957 10.048 8.00722 -4310 4 24.0564 17.0505 18.7104 4.01172 4.3516 -6.8818 -4311 6 30.1789 1.58441 5.83411 4.12275 19.8646 -71.4749 -4312 4 29.4821 1.85802 6.42075 -6.9839 1.28517 8.89789 -4313 4 29.959 2.0434 4.91278 6.77151 -29.6581 61.3265 -4314 6 37.452 25.891 8.43789 -40.1641 -31.4732 50.6902 -4315 4 38.334 25.9927 8.78667 20.6785 -4.95116 -4.15592 -4316 4 36.9881 25.2791 9.14634 19.6253 32.8331 -49.0064 -4317 6 24.7604 7.00734 2.27008 32.0581 9.85747 -12.4546 -4318 4 25.4028 6.31463 2.48931 -5.40489 7.62931 7.6933 -4319 4 23.9158 6.58667 2.26874 -21.5893 -3.78057 4.11792 -4320 6 25.7887 38.8506 10.7619 -30.5475 28.1992 -59.3139 -4321 4 26.3103 38.4194 11.381 38.5207 -12.4255 48.7922 -4322 4 26.1525 39.7259 10.4932 -1.18865 -9.03037 15.3914 -4323 6 0.555207 13.578 28.1388 12.6332 42.7054 11.738 -4324 4 0.341766 12.7807 27.7179 -10.1825 -36.9478 -16.4943 -4325 4 0.413626 13.4435 29.0864 -5.17296 -1.28815 -2.85065 -4326 6 20.4105 17.1191 12.037 -17.9302 -38.4569 -26.5492 -4327 4 20.2295 17.2547 12.9605 -1.34068 5.07474 20.9983 -4328 4 19.8884 16.3005 11.7926 16.4515 20.0565 4.33162 -4329 6 30.9925 7.37797 16.6653 29.7996 22.3073 3.61878 -4330 4 31.2643 7.03844 15.7784 -2.63758 10.9944 17.123 -4331 4 31.7569 7.94595 17.0261 -27.6116 -29.8279 -14.8225 -4332 6 10.2093 5.78517 12.1714 32.5037 6.96704 58.397 -4333 4 10.1014 6.35617 11.4591 -8.08786 32.1119 -50.7901 -4334 4 9.65707 5.06197 12.024 -36.7963 -41.1043 -15.4671 -4335 6 18.4347 31.3493 24.155 3.48135 -6.25246 2.65688 -4336 4 18.4439 30.3878 24.2879 -2.95335 1.71216 0.944019 -4337 4 18.3198 31.7316 25.0273 -3.67252 2.09543 1.27238 -4338 6 27.8948 29.2525 29.2666 2.33504 21.8021 -21.5937 -4339 4 28.3627 29.5914 28.4251 -11.9103 -18.4763 37.4515 -4340 4 28.5196 28.9609 29.9463 14.9294 0.890267 -8.6061 -4341 6 38.3738 15.4456 29.791 12.9945 -28.6313 15.0543 -4342 4 38.0891 14.5036 30.0544 22.1369 39.5396 -7.74746 -4343 4 39.2957 15.632 30.1541 -37.4531 -3.97597 -10.3113 -4344 6 21.7041 34.7992 5.56934 -10.1436 -56.1371 25.2208 -4345 4 21.4621 33.8673 5.89439 16.7439 32.0975 -19.9868 -4346 4 20.9431 35.2741 5.907 -2.46203 13.3807 -4.97838 -4347 6 18.2064 16.8274 1.01093 1.02147 5.09087 9.91972 -4348 4 17.6405 17.264 0.353478 -0.489627 -6.58546 6.49815 -4349 4 17.8529 17.0628 1.89865 0.517006 0.361128 -13.8735 -4350 6 43.5166 18.4972 39.3436 16.5286 13.9247 -42.0759 -4351 4 43.0101 19.1966 39.7112 -21.9319 15.1254 24.622 -4352 4 43.7095 18.933 38.4597 1.00685 -29.3013 20.2287 -4353 6 17.7976 10.0688 35.5434 7.86102 19.599 -20.2005 -4354 4 17.8945 9.40709 36.2105 4.74187 -18.2058 11.3424 -4355 4 18.5459 9.97323 34.9151 -16.2901 -5.18221 9.2364 -4356 6 36.5889 30.5599 29.0828 -33.0481 48.6405 -12.465 -4357 4 36.5132 31.4977 28.7143 1.54088 -37.0728 8.50934 -4358 4 37.4982 30.324 28.9756 25.7485 -11.7594 -3.68806 -4359 6 38.4943 35.9682 10.4222 10.3079 16.2999 40.226 -4360 4 38.6552 36.6966 11.1228 -3.33458 -34.9071 -25.8136 -4361 4 38.3509 35.1294 10.9235 4.16648 17.1849 -3.98913 -4362 6 43.4036 18.8037 34.3607 -18.7725 -42.8138 41.3108 -4363 4 42.9709 18.1893 33.7432 11.3097 10.906 -2.86187 -4364 4 43.2777 18.3171 35.2411 6.94038 29.5352 -30.5758 -4365 6 11.0585 40.2128 6.10885 -15.7783 5.94868 1.16987 -4366 4 11.5965 40.9262 6.45194 10.3679 4.26541 4.32644 -4367 4 10.1443 40.5526 6.13585 6.40705 -5.05479 -5.29954 -4368 6 48.3342 13.7493 24.4707 -3.46168 30.4962 28.8754 -4369 4 47.8576 13.3588 23.754 -13.8134 -6.92474 -20.9085 -4370 4 47.8711 14.5963 24.7134 14.7345 -25.1065 -10.1999 -4371 6 1.47205 25.7712 23.7829 0.184952 23.7651 -2.41746 -4372 4 0.854396 26.4618 23.4919 -3.79407 -11.1699 -2.17794 -4373 4 2.13056 26.3319 24.2122 9.67536 -12.9921 7.11562 -4374 6 20.5856 0.045789 21.1048 4.96875 -22.7073 -7.43464 -4375 4 19.8117 0.249922 21.5931 -19.4423 21.7426 16.1957 -4376 4 20.4519 41.001 21.0443 13.8042 -0.350206 -3.82588 -4377 6 37.6675 12.896 30.7055 18.9575 -14.1068 -43.1025 -4378 4 37.1872 12.5493 29.907 3.14127 2.53034 24.3729 -4379 4 37.0391 13.1763 31.3358 -31.377 6.23238 20.3235 -4380 6 49.4665 17.3801 9.24655 -8.32961 25.946 -15.5009 -4381 4 48.5345 17.665 9.32633 16.3924 -11.5392 1.15372 -4382 4 49.8219 17.9883 8.54454 -1.98957 -21.6031 19.5257 -4383 6 34.3643 5.3502 17.1421 32.952 7.78829 -18.2658 -4384 4 34.6245 5.26975 16.1857 -14.4704 2.64329 20.4158 -4385 4 33.4298 5.20109 17.2262 -20.6176 -11.2241 -0.901893 -4386 6 14.7832 27.6655 0.085624 -10.3553 13.8949 -22.792 -4387 4 14.1034 27.8892 41.3249 2.03342 -11.2849 14.5146 -4388 4 15.1757 28.5319 0.287496 2.39463 -6.00136 9.68974 -4389 6 48.8635 15.5211 20.7504 -7.30397 3.37214 15.1279 -4390 4 49.1252 16.3754 20.4371 0.183023 13.7927 -3.76167 -4391 4 49.1585 14.9241 20.0762 3.93917 -17.6947 -14.7742 -4392 6 23.8074 40.3851 20.3877 -2.3041 21.5375 32.1864 -4393 4 23.5266 40.991 21.1382 8.45078 -18.9812 -28.3519 -4394 4 24.6929 40.0818 20.645 -4.8729 5.63426 -4.96266 -4395 6 35.18 31.4993 13.7142 -38.6695 32.0432 -41.3249 -4396 4 34.2219 31.3119 13.4889 30.0091 9.93153 3.95626 -4397 4 35.4367 30.7845 14.243 12.3636 -35.8089 30.5679 -4398 6 10.9775 9.01115 39.5206 -26.3812 35.8658 -19.2594 -4399 4 10.5557 9.91556 39.5205 15.5031 -28.3669 -8.85108 -4400 4 11.1542 8.87096 40.4393 5.31517 -3.54045 10.232 -4401 6 53.2061 4.88103 16.6049 -20.6689 -12.7794 3.6937 -4402 4 53.6782 5.3887 17.2239 33.7717 25.1716 19.5104 -4403 4 52.5676 4.51498 17.2255 -11.3933 -13.1169 -19.2452 -4404 6 7.83562 33.8039 26.1496 42.0062 50.3869 -17.047 -4405 4 7.62463 34.1533 27.0155 -6.33847 -9.39794 9.82588 -4406 4 8.42034 34.5749 25.7852 -30.6961 -50.8642 6.91563 -4407 6 31.3279 27.9472 6.28298 4.37835 -19.3247 -9.6219 -4408 4 31.922 27.5111 6.93657 -10.4846 5.09347 -11.9486 -4409 4 31.1129 27.3323 5.53276 6.79934 9.76999 15.6259 -4410 6 31.3655 2.17383 41.055 18.9421 -1.98994 34.5993 -4411 4 31.8109 2.17902 0.04034 -17.0754 7.04602 -28.7946 -4412 4 31.2404 1.23747 40.9086 -7.00813 -7.80206 -8.22245 -4413 6 33.7652 4.25739 35.9001 -31.2863 -13.3655 20.8802 -4414 4 34.2485 3.80076 36.6104 5.56552 8.36292 -9.80816 -4415 4 32.8077 4.13792 36.1863 30.7439 3.51509 -16.9094 -4416 6 47.9725 16.0636 29.8584 -12.289 -4.0311 -5.35812 -4417 4 48.7208 16.4163 30.3732 -4.13056 -10.8519 0.408936 -4418 4 47.3533 15.5947 30.4559 16.7379 8.85318 -0.563064 -4419 6 49.3385 10.0935 28.5885 -11.8118 4.56009 -13.0989 -4420 4 48.5886 10.6638 28.8239 3.51911 -4.5157 1.44109 -4421 4 49.3924 10.1159 27.6088 6.69909 -1.91925 15.8757 -4422 6 21.4187 27.7693 29.76 2.80336 -20.4787 -6.37736 -4423 4 21.861 27.2354 30.4624 -7.84738 15.6574 -13.8161 -4424 4 21.1828 28.6282 30.0799 2.10219 20.3695 17.9057 -4425 6 11.6757 39.482 25.8517 13.5538 20.9417 -1.29545 -4426 4 12.2965 38.7786 26.0889 -7.12508 -2.9493 -2.05027 -4427 4 10.8193 39.0846 25.7116 -11.9056 -6.20494 0.0112269 -4428 6 22.9798 39.311 7.85817 -12.7601 -4.86939 -3.04246 -4429 4 22.3059 38.6219 7.95844 1.92638 3.98273 0.136758 -4430 4 22.5772 40.0658 8.31757 9.04497 -1.85468 3.82529 -4431 6 42.5415 35.9278 31.3391 13.0935 -70.9729 -20.1514 -4432 4 42.6447 35.4696 30.4714 -5.52665 5.17936 25.8951 -4433 4 42.5102 36.7973 31.0384 -8.93799 60.9387 2.27408 -4434 6 33.663 14.7412 3.98499 30.4225 -17.693 -39.6888 -4435 4 32.8564 15.2185 4.09596 -24.3526 16.5192 2.50389 -4436 4 33.8944 14.7916 3.00116 -11.9532 1.40502 32.6284 -4437 6 36.697 8.6017 17.5153 18.7294 -29.9333 -4.55465 -4438 4 37.1702 7.95911 16.9159 -11.687 24.5338 13.7544 -4439 4 36.2734 9.25409 16.9543 -7.54123 3.80926 -6.08989 -4440 6 20.8295 32.4146 17.3309 -48.7404 -21.5825 11.0081 -4441 4 20.1664 32.9726 16.9048 10.2664 9.72211 -3.82622 -4442 4 20.2271 31.8015 17.8465 35.2036 12.7196 -8.50107 -4443 6 20.7003 35.3218 14.1083 -3.44914 -18.0461 -19.2112 -4444 4 21.3182 35.5386 13.4099 3.08163 2.90557 -13.4495 -4445 4 20.919 35.9437 14.7754 1.56244 13.5022 22.2067 -4446 6 20.2323 2.51936 40.1651 -9.22326 -14.3688 36.1644 -4447 4 19.7926 2.34354 41.0434 13.5524 6.30823 -28.5037 -4448 4 20.7516 1.7186 40.0171 -1.27786 1.50094 -7.75906 -4449 6 15.0477 14.4672 0.24789 12.9865 -5.55034 -72.7807 -4450 4 15.4827 13.6954 41.6877 -12.87 20.0829 29.6139 -4451 4 15.2186 15.2036 41.5094 -2.93016 -13.2387 23.097 -4452 6 24.8149 37.3373 18.5213 2.43631 -2.68492 27.9859 -4453 4 24.4361 37.9203 17.8611 -0.249038 9.91659 1.71419 -4454 4 24.5604 37.6468 19.4234 0.486379 -6.00228 -23.279 -4455 6 3.16989 27.7944 5.24229 1.80682 -16.6913 61.515 -4456 4 2.664 27.92 6.09489 -0.254446 2.50987 -32.3978 -4457 4 4.0252 27.4816 5.63916 -14.135 1.37322 -28.2843 -4458 6 37.1257 39.0598 36.0573 4.58816 40.5807 23.3296 -4459 4 37.5599 39.5885 36.7783 -22.7086 -1.13864 -22.8071 -4460 4 37.5439 38.2379 36.1828 13.5973 -37.3165 -5.96047 -4461 6 41.3477 16.3672 3.84024 25.8131 6.72768 37.2631 -4462 4 41.4431 17.3182 3.89206 -17.3786 8.01961 -13.1803 -4463 4 42.0046 16.1549 4.54461 -14.0821 -19.2698 -21.0799 -4464 6 15.5755 3.1684 35.3585 1.47298 2.70845 -61.2084 -4465 4 15.1145 3.59171 34.5864 10.479 -16.2188 17.3147 -4466 4 15.2032 3.60881 36.0782 -15.9672 22.7619 40.5269 -4467 6 33.1731 24.2438 7.96729 6.41569 -10.7526 14.1331 -4468 4 33.3408 24.6773 7.1445 11.9115 -7.07525 -26.7187 -4469 4 32.5824 24.8707 8.33408 -19.4303 14.6961 21.7816 -4470 6 35.865 29.7374 15.5979 -29.8607 35.3275 -32.1308 -4471 4 36.7747 29.6672 15.7703 43.701 -12.5229 16.5971 -4472 4 35.3562 29.0371 15.9739 2.56537 -15.478 18.0667 -4473 6 17.5843 36.8354 41.8728 12.1708 -5.57123 -52.5088 -4474 4 18.1833 36.773 0.675699 12.2604 -1.93512 36.5948 -4475 4 18.2359 36.8623 41.125 -21.8566 7.06165 11.6698 -4476 6 26.5622 4.14672 31.1307 -32.6289 -51.1506 -31.7953 -4477 4 27.2582 4.59627 31.5457 41.9615 24.0313 17.3243 -4478 4 26.8928 3.23766 30.8727 -4.86114 29.783 15.5489 -4479 6 31.9552 1.33198 34.4369 -14.3248 -8.90334 35.5546 -4480 4 32.7269 1.15305 34.9944 8.32726 6.02564 -17.2377 -4481 4 31.2642 1.08685 35.0838 -0.545778 4.81468 -20.3916 -4482 6 24.491 14.7534 2.38457 33.2042 -23.9469 17.2683 -4483 4 24.2753 13.9637 2.92779 -7.56186 18.0622 -11.5291 -4484 4 25.4626 14.8414 2.55985 -20.2114 8.54272 -9.97318 -4485 6 25.7566 20.9055 27.5389 -1.15091 7.1508 6.95521 -4486 4 25.459 20.6057 28.4261 8.17968 -1.38894 -17.9407 -4487 4 25.6371 21.8685 27.5748 1.97223 -1.15564 -2.97875 -4488 6 18.1445 40.1527 30.6395 17.3729 -20.3781 15.2884 -4489 4 18.5141 39.2638 30.8544 -10.5973 16.1604 -9.36512 -4490 4 18.9393 40.7073 30.6583 -6.94059 7.54086 -5.9327 -4491 6 46.7889 23.8914 24.5979 7.31075 41.4222 -46.8858 -4492 4 46.2898 24.602 24.0741 10.6002 -32.8666 22.2289 -4493 4 47.4121 23.5287 23.9473 -6.99108 -0.957122 4.26591 -4494 6 45.6201 22.6921 26.5067 -14.1777 -10.0967 -12.8229 -4495 4 46.0372 22.9342 25.6668 -2.41585 -1.26552 16.8561 -4496 4 46.0784 23.1676 27.2003 -0.61408 1.28207 1.11474 -4497 6 20.1006 4.48803 26.6974 -40.8522 40.1383 42.8029 -4498 4 20.2489 5.43817 26.4853 8.37449 -26.4011 -0.951475 -4499 4 20.6602 3.93368 26.2205 34.0606 -24.4352 -38.1565 -4500 6 35.278 26.5864 12.552 0.280065 20.4825 10.9931 -4501 4 35.6728 25.7022 12.4634 2.08478 13.3641 8.87461 -4502 4 35.7774 27.1222 13.2104 -5.20465 -19.6779 -15.4464 -4503 6 3.25879 33.9669 12.2907 -5.01808 -25.4739 5.3677 -4504 4 2.34263 33.6224 12.3201 4.20809 12.7539 -0.381501 -4505 4 3.26735 34.9165 12.3326 -4.58918 17.9212 0.78916 -4506 6 36.6873 1.27899 25.5756 -31.8717 2.25298 32.7844 -4507 4 37.6116 1.37326 25.7779 18.4499 5.6721 -4.77344 -4508 4 36.2122 1.51788 26.4163 6.97172 -2.04149 -25.7728 -4509 6 16.8705 4.65685 24.0413 -35.5309 2.76318 -23.9776 -4510 4 15.8575 4.70434 23.9217 47.0687 -0.0954558 1.21401 -4511 4 17.247 4.33879 23.186 -5.50277 -2.28941 17.9023 -4512 6 39.6565 15.0715 7.80572 25.6093 19.6796 32.1194 -4513 4 39.2854 14.2576 8.13712 -9.42359 -13.1845 -9.18942 -4514 4 39.3628 15.2517 6.91527 -5.26665 -12.4192 -5.15573 -4515 6 9.97948 20.1659 2.91877 -9.38613 14.9664 11.2777 -4516 4 9.63877 20.6452 2.15027 4.12295 -11.9706 -3.67253 -4517 4 9.85969 19.2106 2.80597 1.71997 13.0916 -4.74013 -4518 6 23.4135 4.6314 15.2717 1.19087 -47.3757 24.1847 -4519 4 23.6596 4.57091 14.3636 3.27412 12.4021 -25.8415 -4520 4 23.0767 5.481 15.4712 -5.64379 31.4202 -0.243197 -4521 6 23.5143 41.6409 17.9193 15.1077 8.25095 -6.6202 -4522 4 23.8837 41.2632 18.7444 -17.9015 4.85421 -1.14363 -4523 4 22.6477 0.129763 18.1032 2.89941 -5.9973 3.37217 -4524 6 30.9257 4.8197 1.33225 52.4556 82.2644 21.8498 -4525 4 30.6067 4.04082 1.0087 -28.5575 -73.6424 -29.1188 -4526 4 31.8008 4.99709 0.898826 -20.2281 -12.9509 7.44496 -4527 6 29.2107 33.7595 18.6102 73.0072 -21.2941 -2.29721 -4528 4 30.2072 34.0216 18.5444 -47.9733 -6.17517 5.28057 -4529 4 28.7323 34.5281 18.37 -21.0864 31.3556 1.11974 -4530 6 23.1159 16.7161 3.6681 15.0693 -22.2232 4.2808 -4531 4 23.7494 16.3853 2.99745 -15.1451 3.0429 8.25243 -4532 4 23.0882 17.666 3.59926 -2.15966 11.8771 -4.335 -4533 6 34.9011 26.7664 31.7501 -1.76717 8.52767 -40.8429 -4534 4 35.037 27.6398 31.3273 1.29043 -2.59798 26.5044 -4535 4 34.999 26.223 30.9552 -0.698038 -3.54606 8.98008 -4536 6 7.10213 40.7731 20.9713 24.4432 1.2064 -5.23395 -4537 4 6.57619 40.3882 20.2802 -20.054 -4.79313 -9.64846 -4538 4 7.95521 40.8692 20.51 0.818491 4.17448 7.60026 -4539 6 52.4557 9.69054 11.9333 -13.8891 -19.4181 -13.3487 -4540 4 52.1298 8.88818 11.4535 9.48574 25.0976 13.8313 -4541 4 53.1611 10.0725 11.3936 -7.122 -1.8527 1.23238 -4542 6 12.0235 32.7598 27.7442 3.70099 -7.78602 -3.89203 -4543 4 11.3626 32.1501 27.3892 -5.86407 9.3821 3.02313 -4544 4 12.7405 32.6461 27.1218 9.18069 3.19616 2.31322 -4545 6 15.7918 18.546 0.850378 10.8461 -1.95532 -11.5883 -4546 4 16.438 18.9813 1.41668 1.29405 -2.87095 0.147979 -4547 4 14.9753 18.6242 1.3119 -21.1882 -0.0291689 9.92309 -4548 6 30.9967 13.9378 7.42939 11.475 1.61738 -44.5395 -4549 4 31.0432 13.5913 6.48715 -7.7997 1.97415 36.5778 -4550 4 31.6719 14.6391 7.43931 -7.46887 -7.66354 10.6483 -4551 6 23.9383 39.564 3.55488 34.3001 -22.0749 -10.0269 -4552 4 24.3437 38.8163 4.07249 -17.2972 16.8542 -11.2744 -4553 4 24.6493 39.7352 2.88999 -19.8697 7.819 10.5959 -4554 6 53.2452 13.9576 2.00229 -14.7116 -5.90049 -8.44118 -4555 4 54.0493 14.3984 2.24709 19.6807 0.169927 9.22775 -4556 4 52.9645 14.4205 1.20429 2.95034 -7.59818 -1.70329 -4557 6 29.4557 26.4275 7.80964 12.1022 6.02758 -9.79702 -4558 4 29.9353 26.7368 7.00545 -17.6775 -4.91001 19.2628 -4559 4 28.525 26.2807 7.58748 -5.08244 6.84096 -3.37299 -4560 6 24.6247 23.6022 31.0889 -22.8452 23.3962 -39.3716 -4561 4 23.7242 23.1866 30.9343 31.0198 16.8155 5.56769 -4562 4 24.7802 24.3072 30.3632 -7.32447 -41.3429 34.091 -4563 6 33.6649 19.3163 40.5091 -6.65541 -1.27585 7.81728 -4564 4 33.8354 18.657 41.2044 -1.67667 1.74775 -3.87809 -4565 4 34.3105 19.1562 39.8145 2.0445 4.20075 -4.1701 -4566 6 0.559384 35.9874 14.2134 5.8565 -19.6842 -1.82955 -4567 4 1.23941 35.9463 14.8996 -3.202 15.0395 2.84586 -4568 4 0.030681 36.7785 14.2979 -4.01885 14.7851 6.49139 -4569 6 7.05661 12.759 15.7779 -22.8667 -6.52104 17.6379 -4570 4 6.34583 12.5966 16.4564 20.9558 0.33122 -21.552 -4571 4 6.91757 12.0848 15.0954 -2.34629 3.44815 6.08752 -4572 6 7.88282 3.87818 22.4173 5.89555 -44.5054 15.1514 -4573 4 7.49019 4.56914 21.9267 -7.80716 26.896 -25.5563 -4574 4 7.61791 3.03791 21.9647 5.08594 18.6769 15.1101 -4575 6 50.7471 32.0888 16.2401 1.83727 42.1646 -7.06137 -4576 4 49.8752 31.8312 16.5285 -7.29916 -4.21179 -0.512004 -4577 4 50.6362 33.057 15.9791 5.96194 -37.4522 8.78354 -4578 6 15.303 18.2089 30.059 10.7923 -22.0796 25.2673 -4579 4 14.9011 18.5061 29.2675 -14.0638 14.0876 -27.3921 -4580 4 14.9173 17.3208 30.1974 9.34767 8.93092 3.04247 -4581 6 36.7231 25.4597 33.3812 -54.2725 16.2506 -34.9161 -4582 4 35.9173 25.838 32.8237 55.5216 -11.0114 39.6871 -4583 4 36.747 24.5432 33.1027 5.79642 -6.85026 5.14009 -4584 6 16.5358 21.8507 20.2615 -17.2006 3.10996 -10.5852 -4585 4 16.5318 20.9271 19.9881 4.62491 -6.39719 -1.16283 -4586 4 16.2171 22.3466 19.4835 8.40466 -0.269645 8.83911 -4587 6 44.2784 3.11614 30.075 -4.29151 -10.9085 31.9498 -4588 4 44.2908 2.23086 29.7056 -5.3385 -9.83615 -1.81045 -4589 4 44.5205 3.68982 29.3775 9.49019 22.102 -29.428 -4590 6 51.0822 14.1295 27.7742 -18.732 -33.3382 -1.30318 -4591 4 51.215 15.0658 27.7997 -1.99026 24.8352 -0.164216 -4592 4 50.1181 13.9695 27.6298 18.0185 9.91077 0.913588 -4593 6 54.1414 15.8836 27.1251 18.1892 -50.717 -21.9912 -4594 4 54.5758 14.9905 27.2793 -7.90108 34.3346 13.352 -4595 4 53.8259 15.7459 26.2068 -12.5208 17.6482 15.4671 -4596 6 26.7107 15.1629 34.529 26.3006 32.6175 -12.2305 -4597 4 26.7089 16.144 34.4655 -8.86078 -18.0829 7.52702 -4598 4 27.5163 14.9973 34.009 -10.4907 -11.0891 -0.654257 -4599 6 34.6699 2.22267 27.4725 27.1341 -12.2799 29.337 -4600 4 34.3153 1.93716 28.3227 7.08088 3.88889 7.09202 -4601 4 33.8991 2.25298 26.9555 -28.541 9.30381 -28.496 -4602 6 36.3083 17.6409 40.3953 7.68303 1.60807 9.57574 -4603 4 35.716 17.1791 39.8253 -12.5236 -4.37947 -14.4862 -4604 4 36.6569 16.9265 40.9504 1.18426 15.263 2.6664 -4605 6 26.2972 0.194896 33.0957 0.945324 -1.75644 -10.1569 -4606 4 26.0926 0.771392 33.8475 -8.68516 2.0119 1.91424 -4607 4 25.4691 41.6865 32.8295 -8.00507 -1.67316 12.192 -4608 6 5.19113 35.5773 31.6357 23.2413 -27.7984 27.0466 -4609 4 6.1476 35.7159 31.7435 -10.1506 4.22761 6.12862 -4610 4 4.96861 36.095 30.8978 -11.7512 22.2076 -38.0194 -4611 6 20.2191 22.0354 35.1304 9.30742 -6.19625 19.4235 -4612 4 19.9844 21.2003 34.7289 -5.16022 -6.81034 -3.33987 -4613 4 20.4782 21.7596 36.0473 -3.02096 9.85719 -25.9724 -4614 6 15.9251 36.5949 36.947 -9.13121 -30.7472 31.1466 -4615 4 16.4837 37.3712 37.0549 6.13876 -3.03661 -2.05614 -4616 4 16.031 36.0658 37.8159 -5.1453 16.1721 -39.9007 -4617 6 30.9484 22.4015 3.56131 11.993 -60.8988 -15.4947 -4618 4 31.1008 22.6958 4.44557 1.55935 5.74187 27.4751 -4619 4 31.2551 21.4217 3.58407 -13.4398 43.4536 -6.61432 -4620 6 47.0429 8.40936 14.2086 -4.42011 -15.6298 -34.0486 -4621 4 46.2603 8.29509 13.606 17.325 5.05196 18.7602 -4622 4 47.7698 7.89697 13.7682 -18.8904 11.0332 12.0247 -4623 6 34.1011 18.6159 3.148 0.361877 23.965 35.4915 -4624 4 34.6363 18.3397 3.89922 -0.845538 -0.743075 -4.07575 -4625 4 34.3812 18.1265 2.40098 2.04544 -17.9565 -29.3984 -4626 6 26.7996 25.3961 12.3408 -30.8906 -54.2954 26.5725 -4627 4 27.3117 26.1608 12.4557 20.536 44.4803 3.39785 -4628 4 26.6414 25.0259 13.2528 6.28377 9.49183 -30.6151 -4629 6 22.6108 25.7845 30.8845 17.3255 -0.303924 3.7754 -4630 4 23.4288 25.6954 31.4132 -11.344 -1.13015 -1.03332 -4631 4 22.2314 24.9052 30.7722 1.09512 -5.6623 7.4309 -4632 6 23.6311 9.76276 35.7585 -2.90797 -4.19552 -4.78319 -4633 4 22.8314 10.2832 35.6581 -5.74139 5.63622 4.02691 -4634 4 23.3139 8.86685 35.4998 11.2809 19.0625 6.63709 -4635 6 10.4076 36.7742 9.64242 -28.436 -9.9846 9.32351 -4636 4 9.50067 36.3875 9.59353 19.7531 11.7612 -0.53903 -4637 4 10.7226 36.8301 8.7426 3.69205 5.92187 -13.8772 -4638 6 4.00038 32.4265 25.8669 22.0714 10.4661 11.4497 -4639 4 4.38844 32.9375 25.1422 -1.34031 3.54398 1.69886 -4640 4 3.2706 31.9516 25.4996 -17.8371 -17.4963 -10.4987 -4641 6 29.085 26.0296 18.6527 19.273 -47.5776 11.2122 -4642 4 28.2115 26.0231 19.0264 -21.1607 3.13806 -0.423844 -4643 4 29.4632 25.1291 18.9323 -7.10954 42.4601 -14.5827 -4644 6 15.3089 1.3255 27.9792 -24.1234 20.5069 -17.5654 -4645 4 15.0496 0.974163 27.1169 2.04641 -4.01433 11.5068 -4646 4 14.7355 2.12388 28.0804 19.9995 -12.8223 4.08523 -4647 6 48.6106 2.88816 22.9655 -1.26722 3.55247 -0.201848 -4648 4 48.4165 2.02818 22.6182 -14.5439 -12.5884 3.03438 -4649 4 49.5001 2.98572 22.6432 10.4652 10.9023 -5.33271 -4650 6 53.0075 0.36099 19.7296 11.424 -8.43987 -8.95848 -4651 4 52.5965 41.9022 20.5162 -3.41206 4.78179 6.33318 -4652 4 52.3731 0.223553 19.0136 -6.83989 5.16364 0.289704 -4653 6 1.41074 17.5036 17.9462 -15.7932 -16.9445 -5.36496 -4654 4 1.29993 17.3585 17.0019 -2.92928 12.5396 -5.88676 -4655 4 1.38271 16.6004 18.2823 6.65411 -3.00458 14.0519 -4656 6 37.9084 19.0323 37.6056 -38.9323 8.68785 -13.5971 -4657 4 36.9858 18.7285 37.7384 11.3307 8.89304 -0.372118 -4658 4 38.4207 18.4342 38.1195 19.3518 -17.7067 16.118 -4659 6 26.9813 30.3571 38.0896 -0.527767 18.5171 -30.3811 -4660 4 26.1212 30.285 37.6565 1.23907 -9.17466 9.80696 -4661 4 27.2764 31.2069 37.701 2.1524 -13.2267 12.8694 -4662 6 20.0955 18.5722 3.03696 10.9017 21.9571 9.92937 -4663 4 20.0263 17.806 3.59422 -10.4522 -23.2015 2.62566 -4664 4 20.8322 19.0363 3.46766 -4.52129 0.073665 -16.3651 -4665 6 35.0841 6.94694 4.08385 8.40312 -14.6319 10.4582 -4666 4 35.6826 7.16069 3.3578 -1.64356 4.34706 -6.00978 -4667 4 34.2613 7.42764 3.99145 -7.61312 4.93718 -6.31016 -4668 6 22.2176 37.0878 31.2599 -35.8324 13.882 69.7054 -4669 4 22.1593 36.8558 30.3798 -4.04212 -13.8909 -61.3413 -4670 4 21.2552 37.1952 31.5589 44.4461 1.84169 -14.4682 -4671 6 12.3904 22.3711 41.8265 33.9103 21.3816 -17.5574 -4672 4 13.0623 23.0096 41.4404 -31.3175 -17.017 24.3472 -4673 4 11.7392 22.2302 41.1411 -5.71588 1.3909 -0.895108 -4674 6 43.2333 30.3145 23.1566 26.412 30.0652 1.94466 -4675 4 44.1443 29.9954 22.911 -23.9673 11.2944 4.28313 -4676 4 43.3588 31.2906 23.3811 -4.98348 -33.6726 -4.24118 -4677 6 16.5316 8.07904 16.6592 -13.1305 -2.58289 1.30551 -4678 4 16.426 8.46358 15.7881 -7.07274 -4.02537 -8.52635 -4679 4 17.4421 8.27811 16.8595 11.8389 2.77268 11.6749 -4680 6 10.0527 8.64979 31.7837 -8.97334 17.7557 -57.5223 -4681 4 10.1312 7.90747 32.3291 5.58005 -27.1767 37.8097 -4682 4 10.1183 9.47003 32.2578 1.92783 9.29621 23.4619 -4683 6 10.1389 6.52097 25.6279 25.2027 -9.57639 0.964906 -4684 4 9.42987 6.19895 26.1639 -19.2857 -8.54063 7.31181 -4685 4 9.7626 7.17299 25.0306 4.07146 -2.80849 4.96109 -4686 6 49.8614 7.23714 25.5252 -17.9172 7.62946 -5.56104 -4687 4 50.0467 6.31121 25.4422 2.69032 -18.6529 -6.42341 -4688 4 50.6907 7.63095 25.75 18.9978 12.6416 8.6826 -4689 6 18.4677 37.5766 33.9365 -27.5019 7.45217 1.11424 -4690 4 17.6855 38.1606 34.0956 24.1544 -3.52274 -4.16364 -4691 4 18.0518 36.7105 34.0373 4.53854 -5.63623 -1.47673 -4692 6 32.1991 34.7999 39.2511 37.7035 -28.7103 22.0041 -4693 4 32.3976 34.2973 40.087 0.14143 15.1618 -21.7552 -4694 4 31.3182 35.0784 39.3573 -42.2601 10.9481 4.26487 -4695 6 49.5371 23.9083 4.45427 26.1113 1.30104 -36.4507 -4696 4 49.7626 23.2251 5.06121 8.22711 -23.3511 16.8473 -4697 4 48.7895 24.3154 4.8182 -37.5883 23.1909 21.4935 -4698 6 6.05615 24.4755 33.9372 -3.62864 21.1406 1.2609 -4699 4 6.78781 23.8493 33.8811 -5.98028 -5.90455 -1.42734 -4700 4 5.44033 24.2071 34.6424 10.5748 -4.32926 -7.84557 -4701 6 1.71417 22.9797 24.1919 12.9465 25.751 -13.942 -4702 4 1.74027 23.9063 23.8744 -7.21984 -9.04225 7.93975 -4703 4 0.785802 22.7901 24.3299 -10.4675 -5.82386 8.34916 -4704 6 12.4544 16.5695 32.338 -33.1179 2.9171 31.5337 -4705 4 13.1434 15.995 32.5512 52.391 -27.2499 -12.3732 -4706 4 11.9701 16.4097 33.1768 -13.251 25.8897 -21.4653 -4707 6 21.3776 37.3784 27.9508 -6.73969 12.2577 23.3137 -4708 4 21.2203 37.3231 27.0262 1.16773 -1.52428 -34.5533 -4709 4 20.718 38.0458 28.2038 6.71566 -1.73666 8.03222 -4710 6 27.2299 40.8388 28.8031 2.48401 0.937021 1.60569 -4711 4 26.5367 41.5089 28.9565 6.65702 -12.2841 2.86921 -4712 4 27.4065 40.3185 29.6035 -12.9999 8.55112 -0.224288 -4713 6 0.993205 21.7261 13.5372 -53.3037 2.48171 -36.3839 -4714 4 1.86429 21.8093 13.8237 52.7771 -6.56786 29.3883 -4715 4 0.417346 21.4203 14.2472 8.63216 3.11646 10.526 -4716 6 22.3067 2.58146 8.73662 29.448 -13.2509 35.6107 -4717 4 22.9722 3.05705 8.24165 5.16658 9.50374 -8.2335 -4718 4 21.5154 2.5876 8.23764 -24.8297 4.23497 -21.3736 -4719 6 29.9953 17.8456 8.24313 -2.433 8.62767 -9.90081 -4720 4 29.054 17.6713 8.30654 -5.44558 -4.70631 2.21427 -4721 4 30.3746 17.4275 9.01982 5.69521 -3.15286 8.62416 -4722 6 3.62819 37.7118 25.7099 -17.1271 -24.8271 -10.3244 -4723 4 4.40422 37.1524 25.7956 9.9921 4.76654 4.66524 -4724 4 2.941 37.0477 25.4485 4.12723 25.8155 6.09629 -4725 6 26.809 27.648 36.3589 -37.7802 -17.2474 29.8166 -4726 4 26.8014 28.1831 35.5758 -1.13827 16.217 -13.4241 -4727 4 25.8725 27.5642 36.7259 28.3017 7.35189 -21.1707 -4728 6 13.3559 25.3099 38.116 1.93465 -14.8526 16.0582 -4729 4 13.2959 24.3789 38.4372 3.98877 20.6101 -4.99041 -4730 4 14.1146 25.694 38.605 -5.66874 -3.07699 -9.11419 -4731 6 49.7048 27.2599 6.72622 -1.43928 22.3256 -10.7839 -4732 4 49.6686 26.3369 6.45132 -5.99645 4.70457 -4.8273 -4733 4 49.2845 27.8697 6.04945 8.54794 -27.7312 19.0533 -4734 6 39.7449 11.5776 10.1987 6.84991 -8.95817 -1.04181 -4735 4 40.3059 10.8428 9.86803 -8.86198 19.4731 1.33094 -4736 4 39.0907 11.7833 9.50723 6.52335 -1.56097 1.75374 -4737 6 17.4857 24.9907 35.5559 -11.6728 -0.232318 -1.23817 -4738 4 17.2359 24.7743 34.6481 -9.71541 0.96097 3.2925 -4739 4 18.4326 24.9281 35.5495 18.729 -4.76527 0.24637 -4740 6 45.0886 34.9858 31.8393 -13.7853 -2.59791 -12.3576 -4741 4 44.2542 35.4282 32.0247 4.31579 11.0194 10.5125 -4742 4 44.8031 34.4855 31.0733 13.3341 -13.9746 -4.20839 -4743 6 30.2109 9.89077 31.3202 8.39813 20.0527 10.0978 -4744 4 30.4343 10.7522 30.9233 -1.69236 -11.2354 5.34707 -4745 4 30.0976 10.0887 32.2697 2.61193 -8.5831 -6.90929 -4746 6 32.3748 9.22464 6.61109 37.8815 -39.2378 -50.8405 -4747 4 32.2118 8.68084 5.76454 4.57858 20.451 35.1159 -4748 4 31.5433 9.4233 6.96427 -45.6188 15.529 19.6617 -4749 6 9.26845 24.9782 35.9229 1.19564 -9.02769 -15.4958 -4750 4 8.9564 25.4582 35.1216 5.49795 -4.99978 19.1154 -4751 4 9.87718 25.5584 36.4061 -8.42028 -2.10732 -11.5846 -4752 6 40.3335 1.48296 18.8902 20.9136 0.652934 -58.3414 -4753 4 39.6207 1.94237 19.2768 -32.228 11.5513 31.9135 -4754 4 40.836 0.952532 19.4949 5.43911 -12.9068 21.333 -4755 6 5.27733 10.6166 30.4293 -4.37857 29.6514 35.8012 -4756 4 5.00531 11.4476 30.0112 -0.880507 -1.63534 -8.13264 -4757 4 5.35863 10.9185 31.3957 -0.759826 -20.4729 -25.7258 -4758 6 25.6655 11.6994 25.6535 -15.8411 -39.3949 6.40341 -4759 4 25.8392 12.448 26.1908 9.94197 23.9877 11.5846 -4760 4 25.8146 10.9427 26.2759 4.01869 23.17 -23.7809 -4761 6 21.9208 20.0736 29.783 -0.661059 -23.1285 25.9828 -4762 4 22.5528 19.9674 30.5279 -9.0028 12.6586 -11.845 -4763 4 21.4796 19.2024 29.7633 3.30396 8.80601 -15.8778 -4764 6 10.0031 19.9894 34.5062 10.0701 -18.9504 -1.84201 -4765 4 9.43917 20.4787 35.093 -9.85162 7.82768 6.06887 -4766 4 9.97528 19.0642 34.823 3.96148 11.1077 -9.79004 -4767 6 24.6395 10.3611 12.2013 10.4056 19.7725 40.7349 -4768 4 24.7062 9.53294 12.699 -2.91134 1.50973 -12.3578 -4769 4 25.0089 11.0108 12.8733 -15.5791 -20.8054 -25.2752 -4770 6 50.4386 28.2959 11.551 52.3964 -11.4141 -41.8896 -4771 4 51.2944 28.7096 11.1811 -37.3824 -15.4271 20.8858 -4772 4 50.1484 28.8694 12.238 -9.02874 19.1251 18.783 -4773 6 13.9255 27.6321 25.0575 -30.7043 9.27758 -16.9407 -4774 4 13.4685 27.961 25.8505 6.53671 1.50814 -8.33226 -4775 4 13.405 28.0084 24.2853 19.6442 -13.6277 24.9436 -4776 6 46.1675 18.6723 40.4127 -24.7255 0.52235 -5.51451 -4777 4 45.2163 18.6287 40.1471 17.8616 -3.70574 0.193046 -4778 4 46.2526 19.5549 40.792 -2.63441 -2.56699 -8.45512 -4779 6 32.4875 14.1744 27.1342 -20.1773 -0.115465 -0.458595 -4780 4 31.894 13.6021 27.6676 10.0212 10.5514 -7.27374 -4781 4 32.1329 15.0809 27.2203 4.74838 -8.22403 2.71507 -4782 6 14.0641 36.351 13.3878 -9.69625 43.6715 -7.48797 -4783 4 14.0645 37.3444 13.3555 12.262 -25.9465 20.9036 -4784 4 13.2835 36.2347 12.8457 -5.28255 -22.0231 -7.64651 -4785 6 1.89477 36.5899 21.9857 -12.7075 -7.68583 0.53673 -4786 4 1.75133 36.5712 22.9388 2.01013 -3.06644 8.01032 -4787 4 2.81569 36.8315 21.8421 3.36212 -1.19737 0.805445 -4788 6 25.2943 31.8607 39.7417 -2.48011 0.614033 34.0265 -4789 4 24.999 32.7283 39.4716 -5.73903 6.77443 -6.35095 -4790 4 25.461 31.9431 40.7124 0.191009 -4.33082 -23.8473 -4791 6 6.4797 22.0186 1.29894 -12.0535 -14.7769 -6.17691 -4792 4 5.53353 21.8063 1.36197 11.0348 5.26157 5.70773 -4793 4 6.5732 22.8347 0.80957 1.58971 11.8894 0.78955 -4794 6 27.6266 25.0275 4.69979 7.76412 30.8855 29.066 -4795 4 28.5017 25.4862 4.66738 -16.9061 -15.4428 -5.02391 -4796 4 27.2115 25.3905 5.52919 8.95609 -10.8934 -21.2922 -4797 6 21.6474 30.9429 41.2213 -14.674 16.9935 -31.5335 -4798 4 21.3077 30.3434 41.8509 -10.7705 -24.5884 29.0962 -4799 4 20.9035 30.9616 40.5667 22.5963 5.39714 5.21952 -4800 6 32.3503 18.8691 12.7728 -7.52429 -0.383917 -18.241 -4801 4 31.3918 18.9773 12.8161 6.27066 1.36054 6.85895 -4802 4 32.4619 18.5656 11.8564 12.6246 0.663961 8.91714 -4803 6 35.6352 19.4593 21.1461 -10.1734 29.4522 17.7801 -4804 4 35.3511 18.62 21.5049 -2.07097 -11.6796 -4.30053 -4805 4 34.9906 20.1214 21.5255 16.9121 -20.2959 -15.2058 -4806 6 27.6974 17.9478 34.0105 3.72497 22.7808 11.4532 -4807 4 28.1244 18.3695 33.2449 -3.6365 -3.33971 3.70746 -4808 4 28.0134 18.5196 34.7467 -3.33496 -14.4526 -11.1074 -4809 6 34.1722 39.0415 14.8025 -0.588556 -5.09353 50.87 -4810 4 33.8492 38.3378 14.2426 -9.69809 -4.78927 -2.35124 -4811 4 33.6075 39.0103 15.6476 14.9636 10.6202 -38.8415 -4812 6 28.5063 3.47722 33.8826 -13.8698 -21.2799 4.06498 -4813 4 27.871 4.20321 33.9085 6.20243 8.28698 -1.91661 -4814 4 29.4175 3.76621 33.9059 10.9167 16.0273 -3.84391 -4815 6 34.9231 32.1486 6.55347 -48.5451 -22.9266 3.43697 -4816 4 33.9921 31.9748 6.9467 49.872 11.9331 -17.2337 -4817 4 35.5478 32.1135 7.28146 1.17984 3.66225 6.53991 -4818 6 31.8923 6.87344 23.517 2.73099 13.3553 4.48118 -4819 4 32.4005 6.72509 22.7097 -0.163961 -9.68163 3.8586 -4820 4 32.2042 7.75277 23.812 -2.19309 -5.80853 -1.60196 -4821 6 18.8495 1.74691 0.846251 -10.8424 6.73855 -33.2301 -4822 4 18.128 2.12906 0.287715 7.30697 -5.37966 19.0723 -4823 4 19.1812 2.42034 1.43504 -3.90896 9.02122 12.2654 -4824 6 27.0029 18.9235 11.8738 61.7268 20.0146 -35.0636 -4825 4 27.2277 19.7644 11.4142 7.64396 -16.2258 9.71345 -4826 4 26.1059 19.0334 11.9849 -72.3018 -1.47246 20.779 -4827 6 43.8315 11.1413 18.4425 12.0955 7.77381 31.2403 -4828 4 43.582 10.9955 17.5403 1.6883 -14.8273 -19.2234 -4829 4 44.4878 10.475 18.7348 -4.89818 7.49251 -15.5557 -4830 6 33.4942 40.5585 37.6724 7.87983 -3.11064 16.6213 -4831 4 33.9456 40.2455 38.4765 5.57637 6.44045 -9.71494 -4832 4 32.6057 40.2384 37.8499 -11.5443 1.61602 -9.31227 -4833 6 15.6218 26.7049 39.4143 -33.8245 -53.4627 11.7102 -4834 4 15.4245 26.9754 40.2985 -0.693124 5.44593 20.3253 -4835 4 16.1216 27.3809 39.0562 36.6223 43.7441 -31.7418 -4836 6 4.38199 13.876 40.8778 6.07973 -11.0772 -3.70535 -4837 4 5.33347 13.6897 41.0138 -14.6737 -0.272428 -1.39073 -4838 4 4.02273 13.2235 40.2449 7.64869 11.7946 8.98025 -4839 6 20.1779 10.396 38.2135 -21.4206 4.43784 1.78325 -4840 4 20.3564 10.9148 37.4134 10.9013 -11.3706 0.559506 -4841 4 20.991 10.2443 38.6984 6.99273 1.77474 -1.94206 -4842 6 15.1578 19.2491 23.8705 6.70925 0.197906 -4.49513 -4843 4 15.3523 20.1614 24.134 -1.79925 -4.44488 8.10361 -4844 4 15.0598 19.3463 22.9079 -1.20619 -5.61783 14.9214 -4845 6 47.881 28.6148 15.8048 16.8356 22.7469 11.8397 -4846 4 48.0602 27.74 15.4965 -2.52866 -23.0751 -5.40804 -4847 4 48.6281 28.8091 16.402 -10.5906 -5.01786 -6.93826 -4848 6 29.925 30.905 18.9707 11.7406 3.33263 -1.10353 -4849 4 29.0879 30.4807 18.764 -8.84985 -7.33813 -1.92291 -4850 4 29.807 31.8375 18.7873 -6.04184 4.11832 2.37084 -4851 6 11.9324 35.8064 28.512 -27.4265 24.0258 -21.7564 -4852 4 12.5706 36.1347 29.1334 15.2736 -4.81493 21.8335 -4853 4 12.2236 34.9831 28.145 8.79196 -20.6768 -0.490374 -4854 6 29.967 37.8624 25.4885 4.59009 -4.14727 -0.313094 -4855 4 30.2605 37.0012 25.8228 -4.78695 -0.224547 -14.1967 -4856 4 30.4431 38.4647 26.0537 0.190265 15.5785 7.27405 -4857 6 52.6385 28.1101 32.2696 27.4129 -14.0906 14.429 -4858 4 52.1837 28.8064 31.8018 1.35463 13.918 -3.63194 -4859 4 53.5572 28.4115 32.4361 -8.8806 -0.527566 -10.0859 -4860 6 37.0194 40.0856 11.9811 12.8522 -14.0915 -8.99985 -4861 4 36.2698 40.6335 12.1547 -20.3135 9.86443 5.11387 -4862 4 37.3206 39.8255 12.8594 7.06858 1.59634 4.17732 -4863 6 16.6823 16.7862 36.5016 -40.0159 24.4695 -22.7659 -4864 4 15.9639 17.4464 36.7433 30.1481 -22.6997 -3.51596 -4865 4 16.709 16.8774 35.5181 2.88256 -1.64708 20.873 -4866 6 28.0056 4.17661 38.8341 -15.1907 4.44859 15.1459 -4867 4 28.8664 4.34511 39.2253 10.7528 -1.70638 -4.98709 -4868 4 28.1362 3.72531 37.9969 -2.54795 -6.06729 -7.91519 -4869 6 28.9121 0.2613 17.7196 11.2429 43.6022 -6.13696 -4870 4 28.206 0.913023 17.5432 1.57334 -10.0134 0.986336 -4871 4 28.5175 41.3357 17.883 -22.7122 -29.353 3.51833 -4872 6 22.9275 20.1119 26.272 10.3141 -17.1908 1.54721 -4873 4 23.597 20.0083 26.9758 -6.33812 5.26805 -6.32666 -4874 4 22.343 20.8217 26.5441 4.5912 8.26641 6.04785 -4875 6 49.4104 29.8887 13.4211 -27.0365 40.5227 7.20695 -4876 4 49.0994 30.824 13.2506 14.963 -27.7355 -0.582388 -4877 4 48.6865 29.5209 13.9525 8.18699 -4.12202 2.86767 -4878 6 2.45827 24.8307 7.29137 -22.8365 1.45709 37.207 -4879 4 2.32025 24.5445 8.23446 11.0976 11.5137 -22.649 -4880 4 1.77037 25.516 7.1857 7.09177 -11.7652 -6.70138 -4881 6 30.3948 26.4611 14.3404 -21.8067 20.3233 2.80707 -4882 4 31.1122 26.3224 14.9982 -12.4575 10.0222 -1.69757 -4883 4 29.8137 27.2743 14.5309 34.7851 -33.9666 2.2264 -4884 6 27.0321 32.5068 3.14827 -14.3662 17.1598 1.60641 -4885 4 26.4039 33.1156 3.62616 22.1531 -16.0826 -13.2832 -4886 4 27.3831 31.9163 3.82559 -1.71579 -4.01879 3.19031 -4887 6 34.2634 14.7959 1.27313 2.99828 -7.05923 -10.0889 -4888 4 35.1835 14.4352 1.19997 -20.4533 4.23129 -4.55267 -4889 4 33.713 14.3258 0.588346 24.9828 8.52884 21.9593 -4890 6 30.022 8.54163 1.32868 -10.2939 -13.069 16.6852 -4891 4 30.0052 9.45247 1.0409 -5.08902 11.4157 2.73646 -4892 4 29.2496 8.43498 1.92915 15.9692 5.13326 -10.6744 -4893 6 42.5647 11.5185 27.7103 -4.68909 6.08661 -3.61857 -4894 4 42.216 12.3928 27.8946 9.09127 8.642 -2.18095 -4895 4 41.8714 10.9656 28.0604 -6.00702 -16.6262 4.78299 -4896 6 52.461 39.5492 17.8365 12.2605 -26.0754 -32.0817 -4897 4 51.7553 39.7908 18.3861 -39.7898 9.50592 28.6027 -4898 4 53.1226 40.1801 18.0155 30.5873 23.5517 5.0779 -4899 6 33.2136 4.91918 31.6183 -6.56942 36.6821 16.923 -4900 4 32.9061 5.86322 31.5606 3.78329 -26.1329 5.01225 -4901 4 32.8884 4.48208 30.835 -2.61462 -3.20134 -11.4125 -4902 6 6.2936 16 18.7476 -12.5252 7.31014 22.9936 -4903 4 5.79227 16.5246 19.4216 24.8679 -4.64947 -16.2991 -4904 4 5.64136 15.3462 18.514 -6.08951 -9.62478 -9.34051 -4905 6 8.52033 14.5365 24.6875 -9.84601 3.26611 -2.01077 -4906 4 9.36791 14.3624 25.0978 6.86066 0.30113 1.47813 -4907 4 8.18366 13.6846 24.3866 1.77672 -1.96336 3.84573 -4908 6 22.6911 10.1297 32.1351 -27.5214 -52.5729 10.3709 -4909 4 22.3884 10.9899 32.3649 2.47289 32.4289 -2.22619 -4910 4 23.5203 10.1223 31.6812 20.4751 21.0076 -14.9216 -4911 6 11.292 2.12704 14.679 -26.9964 -14.1635 0.457424 -4912 4 10.3004 2.01295 14.5746 25.662 7.6895 -7.09692 -4913 4 11.7079 2.38272 13.8392 -0.157448 -3.91762 -7.39795 -4914 6 44.9096 15.591 36.2717 33.6405 -1.91298 -30.8875 -4915 4 45.0764 15.4828 35.303 -3.33411 7.1012 27.4883 -4916 4 43.99 15.446 36.3379 -31.2371 -2.78707 10.2167 -4917 6 9.72465 19.0179 31.2227 19.6005 -24.8416 -16.8371 -4918 4 10.5897 19.4265 31.3159 1.30764 -1.40065 3.11778 -4919 4 9.11252 19.5759 31.653 -23.8989 17.913 16.8503 -4920 6 51.9714 7.58847 16.6881 21.0297 -20.8952 -55.8985 -4921 4 52.6598 6.90966 16.567 -10.1825 8.15334 22.1112 -4922 4 51.6538 7.5728 15.7392 -8.87714 21.5211 34.751 -4923 6 31.4317 34.7753 36.422 -0.942044 -9.40807 -31.2122 -4924 4 31.7249 34.7672 37.3268 6.30465 10.9632 14.3566 -4925 4 31.2441 35.6593 36.0754 6.17504 10.5044 11.3925 -4926 6 4.22663 15.0937 15.3657 -12.9272 -11.1361 22.285 -4927 4 4.10058 14.8824 16.3208 1.18356 5.05287 -17.269 -4928 4 5.17453 15.1773 15.2713 12.4851 5.61025 -4.39011 -4929 6 47.7531 20.6767 28.0224 11.2198 -3.02063 -12.9376 -4930 4 47.6925 19.771 27.6598 -2.10862 13.919 9.51432 -4931 4 48.3916 21.1163 27.4231 -12.1395 -0.81062 10.3277 -4932 6 15.815 1.15165 24.4078 -58.142 17.9603 -16.0616 -4933 4 15.2825 0.557615 24.9446 12.6892 -15.3828 1.22604 -4934 4 15.0545 1.63036 23.9524 41.7436 -8.72437 9.7488 -4935 6 34.5811 39.7067 40.0776 25.1973 35.6425 -42.1699 -4936 4 34.2041 40.3093 40.7031 -18.6223 -6.05265 24.4589 -4937 4 34.3171 38.8242 40.1905 -21.7766 -38.3424 16.3885 -4938 6 20.1959 32.1778 34.4064 -21.1308 28.8301 22.4919 -4939 4 19.7756 32.8897 35.0113 13.9702 -37.934 -23.8567 -4940 4 21.1121 32.1056 34.6926 -2.59197 2.17732 9.39736 -4941 6 19.2966 38.5284 11.8437 26.0429 16.0259 -0.414132 -4942 4 19.2747 37.5954 11.9891 -3.91225 -17.7096 3.53088 -4943 4 20.0654 38.8356 12.3915 -17.5462 -2.40166 -9.14392 -4944 6 6.53181 13.5016 26.8314 -26.032 48.4544 -13.2533 -4945 4 5.96734 14.0602 26.204 31.1233 -23.713 24.7575 -4946 4 6.50803 12.6321 26.4707 -0.853216 -24.803 -10.5103 -4947 6 23.5899 31.5666 33.3383 5.98922 -6.50638 -9.93577 -4948 4 23.0479 31.6137 34.1308 1.15429 -4.79335 1.92272 -4949 4 23.6428 30.629 33.0606 -7.31668 7.17491 0.194963 -4950 6 41.0566 31.9249 16.2102 56.5158 -30.8904 -22.4873 -4951 4 41.9283 32.0344 16.659 -25.525 5.07155 -0.752829 -4952 4 41.3339 31.2779 15.4895 -19.0587 21.5349 12.1439 -4953 6 31.7523 18.8667 19.3593 3.35741 25.414 0.712525 -4954 4 32.0759 19.7269 19.7383 -8.81617 -22.0304 -12.3923 -4955 4 31.2718 18.4298 20.0739 7.05067 -2.94537 3.38628 -4956 6 10.4941 4.11052 19.3414 6.42456 29.4713 -33.6332 -4957 4 9.72315 4.57262 18.9428 7.32966 -14.5804 7.11 -4958 4 11.2095 4.33965 18.6811 -15.5987 -11.1936 33.5314 -4959 6 1.36933 32.4682 19.2841 21.0988 -14.4161 24.2075 -4960 4 2.01529 31.7231 19.2122 -13.2253 9.85044 -10.2965 -4961 4 1.01532 32.721 18.4367 5.36339 -4.1954 -20.4987 -4962 6 42.8687 16.8583 24.9978 45.6636 -43.4462 -50.5941 -4963 4 42.5079 17.7172 24.9824 -17.3855 32.283 0.331695 -4964 4 43.4322 16.7911 24.1362 -30.0172 8.55702 44.8961 -4965 6 45.317 19.181 4.10785 3.8422 34.8536 -4.15721 -4966 4 46.019 19.8398 3.89275 -2.03222 -14.2005 10.5278 -4967 4 44.6424 19.7199 4.5744 3.59127 -10.0852 -3.22755 -4968 6 29.1417 19.8939 35.7514 6.11075 -32.58 -16.2332 -4969 4 28.6926 20.3067 36.4515 -23.9686 13.1333 31.3988 -4970 4 29.2427 20.5957 35.1143 7.28783 5.32225 -12.4577 -4971 6 31.9564 21.8498 19.6592 2.82401 14.2352 -0.350828 -4972 4 32.7548 21.9543 19.0677 -31.5105 -7.28354 24.2009 -4973 4 31.6217 22.7614 19.848 10.5207 -20.3739 -6.13763 -4974 6 39.1981 8.2717 18.8284 -32.9061 14.1933 0.428726 -4975 4 38.9624 7.35629 18.6463 1.07118 -6.83808 -1.96228 -4976 4 38.3348 8.76709 18.6863 31.0345 -14.9445 1.78619 -4977 6 33.2818 13.2775 41.2684 -13.2208 -33.3764 1.31987 -4978 4 32.393 13.5626 41.0006 -3.83673 2.91025 7.56978 -4979 4 33.1808 12.3338 41.5845 5.22215 22.8712 -2.04361 -4980 6 5.9413 29.5498 35.797 -32.456 -34.3071 -6.72563 -4981 4 6.35963 30.284 36.1739 22.861 33.0715 10.0739 -4982 4 6.49565 29.1835 35.1072 8.32337 2.91553 -5.44074 -4983 6 13.0321 34.2086 31.915 -24.835 -40.2345 36.8573 -4984 4 13.0272 33.4084 31.376 1.88868 -0.760633 -7.07942 -4985 4 12.5489 33.9041 32.737 18.271 18.5714 -18.1292 -4986 6 33.9591 21.7903 18.011 18.8454 -21.734 -8.71067 -4987 4 34.7458 21.1933 18.012 -16.5142 3.18134 2.17277 -4988 4 34.2934 22.6573 17.8484 16.983 20.6817 -10.003 -4989 6 35.9748 41.3385 18.1559 -11.3515 0.0380054 -35.3696 -4990 4 35.8093 41.5204 17.1769 9.12346 -12.4659 34.6458 -4991 4 36.6045 0.098617 18.3947 7.40652 10.177 5.52403 -4992 6 34.8515 37.6574 30.5934 11.7527 -35.7483 27.3047 -4993 4 35.1492 36.8608 30.1169 2.57906 15.2804 -10.7791 -4994 4 34.9371 37.33 31.5271 -8.43612 19.6249 -16.9201 -4995 6 26.002 34.4146 4.67279 -8.48904 3.78898 9.19231 -4996 4 25.4415 34.5852 5.42871 -16.9308 -4.98482 2.97274 -4997 4 26.7915 34.86 4.9592 18.7282 4.65341 -5.76761 -4998 6 19.0552 33.5605 1.32358 6.49267 31.5074 -37.6332 -4999 4 19.8139 33.1288 1.70335 8.38847 -12.1483 9.88993 -5000 4 19.4402 34.1326 0.589952 -11.7405 -21.1797 25.0755 -5001 6 25.2648 8.23393 8.59155 9.31521 -3.65292 19.8467 -5002 4 25.4875 8.13778 9.5404 -3.07709 1.08931 -10.3145 -5003 4 25.4314 9.16241 8.38927 -1.28134 -0.00667841 -6.07783 -5004 6 12.8479 19.6935 13.0483 24.3757 5.37981 -4.8091 -5005 4 11.9603 19.9957 12.9501 -28.6845 1.86907 1.18076 -5006 4 13.3523 20.516 12.8959 -4.89806 -16.374 -0.906345 -5007 6 53.3502 11.4299 5.80806 17.1624 -7.42289 17.7098 -5008 4 53.8461 12.0471 6.36061 9.49207 -4.93163 0.0376 -5009 4 52.6392 11.9481 5.49246 -25.6427 10.4986 -14.7278 -5010 6 9.84876 16.0411 31.2026 18.9205 20.8399 7.27663 -5011 4 9.06508 15.7062 30.7868 -18.8641 -2.54228 -13.3824 -5012 4 9.84527 17.0253 31.1624 -7.05614 -14.0763 0.861631 -5013 6 25.427 20.2931 3.30062 11.4464 23.222 26.9187 -5014 4 25.5454 20.7694 4.15249 -9.33169 -17.4988 -10.5652 -5015 4 25.6323 21.0333 2.7154 -3.32412 -15.1122 -12.6987 -5016 6 20.7611 8.20749 15.6389 12.285 -44.7943 -30.6071 -5017 4 20.4521 8.55687 16.4556 -20.4937 3.03897 24.5457 -5018 4 20.4185 7.27697 15.5079 3.31214 29.403 13.2982 -5019 6 37.6491 8.60321 9.97383 13.4411 2.14626 39.4708 -5020 4 37.9762 7.71523 10.2023 -7.3296 7.95364 -3.74733 -5021 4 37.281 8.55077 9.10696 -2.37522 -5.79058 -16.8845 -5022 6 50.6587 4.51935 24.2622 -13.5896 -19.0591 8.29097 -5023 4 49.9232 3.87067 24.2726 8.09814 12.5004 -4.89174 -5024 4 51.4381 3.99879 24.4754 4.23299 2.4676 7.18675 -5025 6 20.1738 24.8175 34.9087 -20.6162 39.8894 -22.5586 -5026 4 19.8889 25.4664 34.1955 11.6566 -19.5752 19.2833 -5027 4 20.4138 24.0094 34.4666 -0.241841 -16.354 -5.00311 -5028 6 30.5812 22.5243 11.2258 -36.8716 21.596 38.6978 -5029 4 31.1688 21.9929 10.7494 35.9784 -15.9007 -22.5785 -5030 4 31.0799 23.2498 11.6175 0.71333 3.79074 -7.65826 -5031 6 17.3246 40.781 8.03002 -31.7256 21.6985 11.3561 -5032 4 17.3609 40.073 8.69249 8.70624 -3.14378 -12.3263 -5033 4 18.1517 40.9293 7.58873 21.0517 -16.9909 -7.06703 -5034 6 23.9551 41.0422 26.0635 49.9815 4.82526 35.6353 -5035 4 24.3667 40.5978 25.3173 -4.54613 -3.84774 -13.2149 -5036 4 23.0402 41.1884 25.9461 -38.539 -4.36769 -14.447 -5037 6 9.79432 25.5848 27.2203 6.65484 -20.1236 -27.319 -5038 4 10.0774 24.9678 26.4912 -4.54744 21.2611 22.5851 -5039 4 10.2742 25.3181 28.0139 -2.97183 -5.43805 2.20583 -5040 6 35.2559 29.8148 24.7567 4.66903 26.9266 -5.93859 -5041 4 34.3843 29.755 24.359 -8.51564 -12.4096 -2.57191 -5042 4 35.4992 30.7322 24.5163 3.09853 -9.53322 8.65044 -5043 6 2.14554 4.24448 10.5593 -22.2482 14.7122 10.1934 -5044 4 1.71214 4.34677 11.4486 21.0071 -10.277 -13.7719 -5045 4 1.55235 4.73342 9.96914 3.10164 -3.012 2.95666 -5046 6 43.1737 3.93442 23.504 -19.8173 -22.9925 0.828755 -5047 4 43.8868 4.03822 22.8829 13.7397 8.75634 -8.56433 -5048 4 42.5624 3.30318 23.0634 7.12322 11.7882 3.68849 -5049 6 18.8936 22.6308 2.43475 37.4693 -11.6119 5.39147 -5050 4 19.8359 22.2985 2.41568 -31.8063 3.38645 -2.45846 -5051 4 18.7431 22.7947 3.37318 -4.67781 1.83629 -1.28906 -5052 6 20.5039 18.9394 41.5502 -45.0653 -1.00263 50.2155 -5053 4 20.0478 18.6838 0.506021 30.3651 -1.16827 -32.2456 -5054 4 19.9073 19.6506 41.2865 12.7012 -1.26976 -15.3796 -5055 6 26.407 7.54687 29.1121 1.4357 2.47637 1.41449 -5056 4 25.6724 7.10479 28.6297 19.9382 8.96422 9.98625 -5057 4 27.0918 7.77745 28.4582 -11.2115 -7.41118 6.83701 -5058 6 25.6474 35.5684 33.7551 28.3954 -27.4775 -24.9773 -5059 4 26.3573 36.1942 33.5448 -9.56627 7.56335 10.8035 -5060 4 25.9974 34.7724 33.2466 -29.6941 19.0168 23.1671 -5061 6 24.829 0.49304 8.41898 49.9168 25.8876 59 -5062 4 25.5758 0.370102 9.1289 -47.1903 5.46774 -40.7742 -5063 4 24.7798 41.5674 8.0141 -4.73142 -31.3088 -22.2887 -5064 6 17.0191 17.3177 3.44507 -46.3903 19.7373 51.2207 -5065 4 16.2469 17.9517 3.64762 33.8447 -23.651 -21.8207 -5066 4 17.1185 16.9245 4.35427 5.98982 5.76213 -27.3591 -5067 6 40.1787 32.0965 19.3495 -2.04197 44.459 1.39821 -5068 4 39.7315 31.3261 19.6693 2.08081 -28.8107 0.337304 -5069 4 40.9568 31.869 18.8472 6.84111 -19.9226 -1.15348 -5070 6 23.382 26.6945 6.30636 26.5913 52.1271 15.5788 -5071 4 24.0556 27.4456 6.44648 -17.1373 -33.2326 -1.34025 -5072 4 22.7142 27.1153 5.75328 -6.08389 -4.52619 -7.61988 -5073 6 28.6524 28.5085 1.41248 40.8971 -13.4399 -11.1281 -5074 4 28.8916 29.4207 1.30452 -22.1266 20.7664 -4.28256 -5075 4 29.5558 28.1704 1.18501 -32.1523 -8.03877 13.3744 -5076 6 12.0456 6.33448 14.0345 -15.8903 -34.4 -29.7535 -5077 4 11.2902 6.05291 13.4483 16.0844 18.9407 21.6686 -5078 4 12.7823 5.99392 13.4906 5.33453 16.7776 14.1371 -5079 6 20.1258 33.7078 32.0959 -18.1893 1.56867 -4.93457 -5080 4 20.1945 33.0222 32.7471 -6.29187 -8.74149 18.477 -5081 4 21.0272 33.8529 31.8657 20.6776 7.89431 -10.0095 -5082 6 12.0665 33.3691 34.5458 -17.2285 -56.0193 -22.1145 -5083 4 11.5086 33.8793 35.1106 -7.76206 16.4549 16.9315 -5084 4 11.5605 32.4987 34.4127 27.4292 33.0374 0.608769 -5085 6 6.00658 22.2666 25.0532 -19.3255 -5.39958 94.237 -5086 4 5.834 22.4197 24.1868 -9.01045 11.6196 -89.8037 -5087 4 5.17345 22.6031 25.4913 31.6285 -9.76338 -3.83253 -5088 6 28.8848 9.49767 11.035 16.7623 9.63116 22.4077 -5089 4 29.0495 10.2086 11.6768 10.1151 -22.3542 -11.392 -5090 4 28.083 9.83925 10.6889 -25.6685 -5.48517 -25.0151 -5091 6 25.9808 31.1499 24.8669 6.22835 -24.9986 7.12483 -5092 4 26.2942 31.9621 24.5011 4.31737 18.7644 -10.9339 -5093 4 26.6597 30.4768 24.6157 -18.0541 8.02771 8.13926 -5094 6 17.4051 22.6403 26.9653 -7.75883 36.9734 2.0054 -5095 4 17.2144 23.5004 27.4753 3.96627 -41.4428 -18.3441 -5096 4 17.5261 21.9375 27.6083 1.93016 -8.19761 6.25563 -5097 6 30.9714 17.6252 1.64088 21.0154 14.9482 37.3685 -5098 4 30.2059 17.6112 1.0839 -20.4324 5.80492 -14.3468 -5099 4 30.9516 18.4373 2.23396 3.22156 -25.7853 -22.8165 -5100 6 35.2764 9.72503 11.2414 -18.3895 -2.76749 -51.624 -5101 4 34.6551 9.56245 10.4589 20.7383 2.80865 37.1903 -5102 4 36.1302 9.43155 10.8742 2.68762 -2.05229 10.7544 -5103 6 12.0172 10.802 4.27563 -38.9121 -6.07101 -4.90761 -5104 4 11.4313 10.6374 5.04504 13.8247 1.49432 -7.40831 -5105 4 11.4074 10.5604 3.53263 22.811 5.33779 9.30002 -5106 6 52.9577 23.1313 7.67787 -9.3269 3.09364 -7.79077 -5107 4 53.8153 23.0871 7.22609 1.51949 2.98805 -1.25247 -5108 4 52.6879 24.0607 7.78743 10.5919 -6.87524 0.0783357 -5109 6 27.3762 5.80009 23.1013 37.771 37.8703 25.2466 -5110 4 28.2178 5.56094 23.5856 -32.2451 -1.57897 -13.9899 -5111 4 27.4704 6.79781 23.0764 -15.1432 -38.3322 -6.34326 -5112 6 22.7771 37.7063 15.5287 -6.89324 -10.2053 44.7861 -5113 4 22.8198 37.7465 14.5962 3.81902 5.91484 -35.4551 -5114 4 23.2903 36.9427 15.8415 -1.83068 2.7653 -4.67104 -5115 6 30.583 30.1381 39.7472 11.9278 5.78959 4.89923 -5116 4 30.1399 29.6129 39.0656 -4.27402 4.25284 -2.63349 -5117 4 30.6547 31.067 39.4612 -8.3831 -13.7724 -7.9353 -5118 6 26.5154 14.8633 29.9609 11.0831 -12.5589 -33.9006 -5119 4 25.6935 15.2477 30.2118 -18.1143 15.4408 19.147 -5120 4 27.1376 14.9035 30.6723 6.99544 5.71887 23.1856 -5121 6 9.52617 19.5446 37.4141 -27.8096 33.0225 -3.94279 -5122 4 8.56344 19.6819 37.5998 22.5694 -19.9005 4.13551 -5123 4 9.71087 20.3892 36.9619 8.68778 -16.8671 10.038 -5124 6 0.93064 14.8656 2.69338 -45.7679 -11.5139 71.6593 -5125 4 1.44105 15.217 2.01526 37.3122 25.2366 -40.5783 -5126 4 0.982855 15.4275 3.5214 11.2099 -15.0526 -29.9277 -5127 6 46.4291 27.1302 41.5927 44.8021 -5.11347 -18.4756 -5128 4 47.4269 27.1857 41.3316 -52.8753 -1.56841 10.8767 -5129 4 46.0453 26.5632 40.9031 3.09365 7.20255 7.14326 -5130 6 47.6703 23.0461 21.3817 14.1329 62.5249 18.4178 -5131 4 46.9615 23.2467 20.7836 -14.1781 -2.67912 -10.5965 -5132 4 47.8255 22.1376 21.4096 0.736735 -54.6337 -3.62162 -5133 6 39.861 22.2186 3.09273 14.3751 -13.6386 -17.8056 -5134 4 38.9812 22.2192 3.47284 -7.54245 -0.786418 6.90323 -5135 4 40.0217 21.2868 2.78929 -10.5756 29.8648 14.1337 -5136 6 14.9857 14.9315 33.4628 8.45923 30.4043 17.83 -5137 4 15.3946 15.8263 33.6275 -11.7248 -28.7506 -9.93609 -5138 4 14.5839 14.7058 34.318 1.67348 -1.86342 -8.89677 -5139 6 27.3225 11.4951 31.9326 -53.5602 -46.3542 13.457 -5140 4 26.8632 12.0627 32.5566 10.8872 8.4751 3.08438 -5141 4 28.1269 11.8297 31.6518 53.6341 36.944 -15.9306 -5142 6 36.7606 7.97817 7.63938 -5.6216 -14.483 -15.6739 -5143 4 35.961 7.43887 7.80711 8.78578 3.79539 -7.6162 -5144 4 37.414 7.37034 7.2323 -6.45073 3.96969 3.37374 -5145 6 49.4351 9.64395 18.2091 29.626 55.2849 10.866 -5146 4 50.1121 10.1978 17.7651 -9.80365 -29.4086 -13.348 -5147 4 49.2806 10.2909 18.9191 -22.4891 -21.6225 2.73598 -5148 6 27.0558 33.8708 10.7695 -35.2964 21.4972 9.63291 -5149 4 27.0077 33.3399 10.0051 13.5655 -23.8621 -34.587 -5150 4 26.1863 34.3133 10.6733 10.9844 1.63438 18.9088 -5151 6 11.1931 37.467 6.82672 4.88099 -16.6436 19.1561 -5152 4 10.8369 38.341 6.72067 -6.30082 13.8936 -5.38019 -5153 4 12.1372 37.6177 6.93955 5.33816 -5.06614 -4.03667 -5154 6 19.2682 19.4041 21.904 -23.2853 8.1035 46.9014 -5155 4 18.5523 19.4276 21.2977 -21.2798 -5.04156 -20.5384 -5156 4 20.0545 19.4439 21.4012 35.6905 -5.22778 -21.4405 -5157 6 54.5004 2.91828 22.5705 32.5661 -1.01917 48.733 -5158 4 54.2618 3.02388 21.6728 -2.16971 10.501 -40.9175 -5159 4 0.435524 3.25313 22.7695 -30.9494 -6.38648 -13.13 -5160 6 45.0599 10.868 24.2364 14.5135 -18.2796 4.13426 -5161 4 44.3635 11.4663 23.9664 0.226806 13.7258 12.1538 -5162 4 45.5813 11.1999 25.0017 -10.9868 0.331296 -15.4884 -5163 6 14.3917 34.4176 24.7766 -9.76404 -18.453 -6.38428 -5164 4 14.7761 35.2693 24.9957 4.99605 2.44674 1.2141 -5165 4 14.8449 34.0832 23.9904 0.575187 7.45256 -7.27956 -5166 6 50.5869 17.5623 4.30497 19.1488 -58.6727 24.3661 -5167 4 51.3501 17.8958 4.78847 0.670503 12.5806 -1.04554 -5168 4 50.1422 18.2474 3.88142 -19.7161 48.0777 -23.3625 -5169 6 14.9242 33.337 34.1076 -18.6172 33.5363 80.554 -5170 4 15.0808 32.9083 33.3321 11.226 -38.5345 -73.3592 -5171 4 14.0723 33.0217 34.4665 7.96171 10.4343 -9.42002 -5172 6 20.8631 33.5747 38.9135 21.2953 11.2024 -25.7312 -5173 4 20.865 34.0752 39.7143 -3.94121 7.45437 24.6588 -5174 4 20.36 32.7884 39.0656 -12.436 -21.6406 1.81461 -5175 6 7.7707 4.74963 26.7362 26.5342 -10.6541 19.1955 -5176 4 7.23261 4.91898 27.5026 -6.83786 10.9421 8.37469 -5177 4 7.15089 4.73593 26.0203 -3.95236 1.60233 -15.9617 -5178 6 9.2875 21.4887 22.2941 45.0197 -19.5209 20.7118 -5179 4 8.6739 21.9912 21.7696 -4.21454 15.1903 -23.2464 -5180 4 10.2572 21.6206 22.0058 -46.5259 5.6334 -2.177 -5181 6 20.5439 38.2154 8.85856 -11.8412 3.64647 49.7312 -5182 4 20.3505 38.5634 9.79035 9.75602 -4.66312 -40.2998 -5183 4 20.2844 37.2891 8.95048 10.2824 2.6457 -7.05014 -5184 6 30.1005 39.0839 30.7484 -12.1958 38.1552 23.9792 -5185 4 30.3724 39.9578 31.2326 -12.541 -45.9124 -25.2432 -5186 4 29.1103 39.003 30.8437 30.6219 6.07536 -1.13857 -5187 6 16.0462 22.036 24.5064 2.37861 -9.55962 -5.99251 -5188 4 16.6334 21.9741 23.7207 6.17482 7.89117 19.2285 -5189 4 16.5569 22.3155 25.2979 1.4399 -2.17025 -8.02685 -5190 6 5.74172 29.2061 14.4603 -14.7312 11.1013 -1.58992 -5191 4 6.41865 28.6839 14.8489 24.8954 -16.4528 0.429681 -5192 4 5.37542 29.618 15.2515 -13.4536 5.99623 -6.25212 -5193 6 28.0689 3.08071 25.2267 -3.20814 35.3244 14.901 -5194 4 28.6407 3.76435 24.8336 -2.36389 -14.401 -4.10269 -5195 4 27.6795 3.6106 25.9691 7.41152 -23.0621 -10.2478 -5196 6 45.9381 29.3111 31.4283 -35.5447 25.9568 9.82539 -5197 4 45.677 28.707 30.7493 2.31008 -18.1922 -21.3643 -5198 4 45.1265 29.9079 31.4744 34.4717 -15.8255 11.1052 -5199 6 11.2229 22.8376 36.7897 -1.27591 2.9175 -5.69903 -5200 4 10.6623 23.4314 36.25 10.4728 -5.78036 -0.0474996 -5201 4 12.0147 22.5841 36.2713 -9.37786 4.28983 5.66853 -5202 6 18.9444 40.1485 39.92 -15.471 -8.01044 2.33142 -5203 4 19.1439 39.1941 39.9507 -1.34087 5.25319 4.4419 -5204 4 18.8847 40.4877 40.8271 3.43659 -8.21326 1.76593 -5205 6 23.5503 26.0803 21.2869 1.98517 -8.46863 16.2364 -5206 4 22.847 26.649 20.9475 -0.393515 -5.32061 4.06564 -5207 4 23.2913 25.6403 22.1336 -2.29953 13.2014 -21.5927 -5208 6 16.8518 5.38834 15.8565 -25.8193 5.07215 -6.0744 -5209 4 16.3979 5.3834 15.0179 8.08064 -16.6857 -11.3384 -5210 4 16.3642 6.13153 16.2159 17.5374 8.90145 23.838 -5211 6 12.0293 26.6115 15.0052 48.8575 28.3431 -20.5386 -5212 4 11.753 25.9113 15.557 -22.1508 -25.2102 16.954 -5213 4 11.3677 26.9943 14.4309 -20.7091 -9.23994 -0.184726 -5214 6 14.3404 41.4231 2.37222 21.8802 31.2536 -15.2067 -5215 4 13.6639 41.0433 2.88545 -29.1815 -25.4177 23.2655 -5216 4 14.3137 0.446574 2.65591 6.04323 -12.5169 -2.89291 -5217 6 50.3994 35.8721 9.32148 7.74023 -5.00078 -0.0244409 -5218 4 50.7985 35.7097 8.44539 1.7624 12.9821 5.72804 -5219 4 50.9327 36.5364 9.8137 -9.76519 -8.88391 -14.7497 -5220 6 11.3732 22.6657 26.8674 13.5542 4.36995 9.37334 -5221 4 12.2226 22.4007 26.49 -3.86507 -2.48494 3.34128 -5222 4 10.7274 22.4174 26.2153 -14.8849 -5.84603 -9.40936 -5223 6 8.44501 34.5567 21.2657 -4.1178 -59.9386 7.63204 -5224 4 8.06567 35.1301 21.9247 -8.42944 2.78434 16.8569 -5225 4 8.10966 33.58 21.4462 13.1168 58.8803 -11.2866 -5226 6 9.4289 8.66253 24.4817 -31.3326 14.2813 -20.5935 -5227 4 8.45611 8.64572 24.2655 24.8039 10.7682 6.42659 -5228 4 9.52915 9.21836 25.2644 -0.461641 7.68001 5.20174 -5229 6 32.603 22.3274 34.5057 1.1064 -2.38466 -37.2003 -5230 4 32.4525 23.1707 34.0368 4.85154 -2.46017 7.68642 -5231 4 32.8396 22.5701 35.3818 7.58742 14.9461 32.9529 -5232 6 26.736 26.1837 7.12165 10.4716 16.8024 -17.1295 -5233 4 25.9537 25.8031 7.51207 -7.84415 -15.2109 12.7352 -5234 4 26.4604 27.1054 6.93432 8.77765 -19.2484 4.4957 -5235 6 34.0014 11.9295 3.96807 -3.56186 4.82634 5.33773 -5236 4 33.6494 11.5631 4.78494 7.3544 2.33703 4.85457 -5237 4 33.8594 12.8842 4.06904 0.478869 -2.08104 -5.13073 -5238 6 21.473 20.924 37.1992 5.8677 19.4674 12.3893 -5239 4 22.3242 21.3752 37.157 2.6693 1.87465 3.04951 -5240 4 21.708 20.0203 37.0255 -6.20277 -25.1527 -1.47337 -5241 6 18.4792 41.0219 0.672743 -35.2491 -25.3697 -26.4792 -5242 4 17.5363 41.1592 0.451811 6.2729 -6.09178 6.10687 -5243 4 18.7532 41.8934 0.847545 18.5165 37.9853 8.81983 -5244 6 41.3458 41.7141 25.1818 17.8335 14.8146 -1.57438 -5245 4 40.8444 40.9381 25.3951 -6.7286 -20.9895 5.67055 -5246 4 41.5773 41.6158 24.2546 -2.61686 2.51709 -2.2804 -5247 6 27.6337 28.128 3.93443 68.2433 49.922 -72.4808 -5248 4 27.747 28.0641 2.90056 -5.60951 6.59214 55.905 -5249 4 26.974 27.5707 4.19301 -60.7891 -51.6503 16.466 -5250 6 18.2766 10.5218 31.4985 31.6557 -13.945 -4.11948 -5251 4 17.4661 10.038 31.5755 -21.8827 2.32902 1.26527 -5252 4 18.1351 11.463 31.4681 -8.30794 8.79106 3.21692 -5253 6 11.3047 37.9513 14.7719 14.2766 22.5792 8.51892 -5254 4 10.8196 37.2524 14.3384 -3.55752 -10.2024 4.33151 -5255 4 11.8722 37.607 15.4977 -19.1201 -2.12261 -16.4117 -5256 6 0.810718 18.1323 27.5767 30.9572 19.3393 -0.702274 -5257 4 0.190255 17.4711 27.3024 -13.6082 -17.9307 4.12615 -5258 4 1.6652 17.6816 27.7433 -15.3641 2.36995 -0.952151 -5259 6 36.7957 10.7342 20.2882 16.9593 17.0847 7.18326 -5260 4 36.2525 10.0089 20.0111 -13.8544 -11.0907 -5.31633 -5261 4 36.5766 10.8708 21.2175 -0.466777 -2.92115 4.06643 -5262 6 47.4269 25.5204 8.035 -8.77625 7.04012 -26.0141 -5263 4 47.2351 25.672 7.07342 16.0738 -5.10236 26.6147 -5264 4 46.6031 25.1946 8.38488 -7.38433 -0.0309169 8.21918 -5265 6 13.9121 35.1279 15.9963 57.6206 21.904 15.8158 -5266 4 13.18 34.6338 16.2776 -41.6081 -30.4219 4.97616 -5267 4 13.8612 35.4714 15.1124 -11.7278 3.29634 -19.5683 -5268 6 29.56 35.3617 16.1847 -46.2751 8.28104 -14.7299 -5269 4 30.2098 34.9035 16.6971 16.3841 -9.08849 15.1595 -5270 4 28.6495 34.9755 16.3324 34.0842 8.73794 -6.93478 -5271 6 29.4892 25.8842 32.4194 -24.256 -10.4352 -29.1805 -5272 4 28.8256 25.7516 33.0892 -1.91161 2.59937 23.0953 -5273 4 29.0388 25.4531 31.6468 24.6149 5.96309 7.68736 -5274 6 24.1242 2.12171 25.4449 33.2745 25.8541 -21.7468 -5275 4 24.4973 2.84525 24.8288 -6.14236 -31.0627 26.9036 -5276 4 24.7925 1.39916 25.5361 -16.9688 12.032 -10.1501 -5277 6 4.54733 34.4389 19.1463 -35.302 -7.10976 -3.39284 -5278 4 4.35486 34.5879 18.2161 16.9971 0.874352 -7.12679 -5279 4 3.63202 34.4395 19.5005 25.743 -3.14875 11.9651 -5280 6 10.1206 17.2361 14.3164 8.36708 -29.6599 -28.3251 -5281 4 10.306 17.5039 15.1955 -0.106022 16.7729 24.4966 -5282 4 9.5035 17.8022 13.8616 -7.59249 10.3925 2.01091 -5283 6 21.4437 41.7724 34.6698 -12.6382 -8.67476 11.1219 -5284 4 21.3209 41.1297 35.367 19.1323 -10.7035 11.8578 -5285 4 20.52 0.052046 34.4982 -0.738196 4.11389 -17.598 -5286 6 36.1618 24.1149 12.6039 -38.5184 -29.276 -18.6614 -5287 4 35.5274 23.7914 13.2897 25.4622 4.78071 -2.2183 -5288 4 35.751 23.7447 11.7708 17.6549 15.9976 15.8112 -5289 6 49.5813 18.6026 19.9424 19.3655 4.31785 -3.79274 -5290 4 50.05 19.3681 19.5461 -11.4841 -9.87428 2.01803 -5291 4 50.2881 17.9408 20.0283 -8.44417 3.53865 1.64593 -5292 6 1.24663 7.05846 14.4912 39.2605 -25.8072 -27.0237 -5293 4 1.83321 6.85564 13.6734 -27.5618 7.792 37.3713 -5294 4 1.40902 6.33035 15.1313 0.69425 14.6008 -10.3474 -5295 6 12.7431 22.7725 31.2519 -28.0711 -22.2846 -24.537 -5296 4 12.731 22.0484 30.5842 -1.03989 14.4355 17.1556 -5297 4 13.6361 23.0601 31.2889 29.0982 7.61123 0.941905 -5298 6 8.17623 18.6217 27.8167 28.4831 -7.95646 -20.137 -5299 4 8.40342 17.6669 27.8028 -7.19499 14.8132 8.92302 -5300 4 8.90402 18.9943 27.2753 -13.5351 -1.9306 8.34595 -5301 6 52.1398 28.0368 15.3061 -5.99984 -2.63203 -6.56281 -5302 4 52.212 27.4921 14.5152 3.50742 -7.1981 5.43712 -5303 4 52.1344 28.9249 14.9274 -1.52971 -5.17654 6.68842 -5304 6 52.6974 21.8977 10.081 -19.9085 6.90605 5.3514 -5305 4 53.3388 22.3376 10.626 19.2735 6.64212 5.60719 -5306 4 52.8023 22.3165 9.21858 0.448532 -1.39229 -3.54893 -5307 6 22.3312 5.79987 2.67028 14.2956 -6.96789 22.7666 -5308 4 22.4342 5.66665 3.62826 -7.95027 2.50856 -4.24886 -5309 4 22.7763 5.02131 2.34757 -2.68692 -18.1597 -17.0707 -5310 6 15.4178 16.2178 21.8878 29.1139 16.3559 -34.9346 -5311 4 14.4763 16.1482 22.0206 -17.0561 3.51129 1.66656 -5312 4 15.5967 16.6295 20.979 -16.1676 -12.6325 35.129 -5313 6 28.6996 41.2944 33.8986 -0.299799 0.972013 4.01662 -5314 4 28.6528 40.5712 34.5346 5.69191 -6.81028 -1.89437 -5315 4 27.7925 41.4039 33.5788 7.00998 2.71453 4.16387 -5316 6 9.0271 31.2603 18.2166 -24.0632 3.5617 9.69965 -5317 4 9.00312 32.2249 18.3215 -0.833429 -0.795431 1.49639 -5318 4 8.39564 30.8695 18.8792 23.5138 4.17381 -14.686 -5319 6 20.5401 20.4009 18.1765 -9.82111 13.5354 -7.0052 -5320 4 21.0961 20.6619 18.9088 6.00228 -1.57494 14.3732 -5321 4 19.8969 21.1451 18.1138 9.42471 -20.4088 -2.28899 -5322 6 53.9632 14.7108 37.8185 38.9936 -13.777 37.4998 -5323 4 53.5065 15.4999 38.0588 -19.2143 21.2037 -5.62994 -5324 4 53.6553 14.2856 37.0504 -18.643 -5.89619 -29.3657 -5325 6 28.9005 15.3805 18.8553 43.4355 2.75939 -10.7082 -5326 4 29.8744 15.2601 18.5577 -43.1698 -4.30042 15.6378 -5327 4 28.8821 15.3937 19.8257 1.95554 -2.72042 -0.550014 -5328 6 2.00757 25.8231 18.9102 1.56834 13.1457 16.4238 -5329 4 2.16994 26.6099 18.3718 5.10623 3.14141 1.15535 -5330 4 1.76535 25.1325 18.3092 -5.75322 -15.1157 -18.9078 -5331 6 53.2586 40.7003 24.294 -3.95682 23.2035 5.10337 -5332 4 53.3627 39.7881 24.0333 10.577 -13.1769 -1.30533 -5333 4 54.0929 41.151 24.0537 -8.8009 -7.19084 1.91562 -5334 6 47.531 32.0044 22.8424 -9.22212 4.73076 14.8806 -5335 4 47.3777 32.6735 23.5302 -5.63931 6.65432 -9.88941 -5336 4 48.2144 31.4763 23.2497 9.41484 -5.26157 -3.09765 -5337 6 24.6289 26.1478 33.0175 -22.0968 -9.02062 -12.6011 -5338 4 24.4656 25.5474 33.7557 -1.10221 8.12594 5.97613 -5339 4 25.4283 26.6445 33.1202 14.9272 4.196 4.65224 -5340 6 21.3417 17.0876 39.4763 -6.70912 6.89414 0.748051 -5341 4 22.0272 16.5901 39.8927 14.9242 -9.38388 2.18929 -5342 4 20.9728 17.5957 40.2063 -4.43123 6.71259 -1.60026 -5343 6 11.0417 40.4515 17.0271 -4.84825 -47.9733 -31.3307 -5344 4 11.617 41.1325 17.3235 21.4854 16.9952 0.793724 -5345 4 11.529 39.8797 16.3454 -22.439 27.66 32.3414 -5346 6 20.3522 21.2696 39.8718 -25.2322 13.8952 23.2629 -5347 4 20.7065 20.9823 39.0558 13.3567 -12.8249 -34.1322 -5348 4 21.0787 21.2544 40.4999 1.2931 1.07094 1.93889 -5349 6 2.11891 29.6947 22.5962 -10.9271 -4.15175 -1.48688 -5350 4 1.41229 29.0196 22.6861 11.0269 1.69063 -12.8134 -5351 4 2.97173 29.2673 22.4434 -6.16143 -1.40449 -3.11444 -5352 6 36.756 30.301 35.4561 22.3149 -30.6991 6.56967 -5353 4 36.1659 29.9908 36.1617 3.98829 10.9575 -2.82389 -5354 4 37.5905 29.761 35.5884 -25.1141 24.4323 0.251817 -5355 6 12.9563 4.31922 37.9158 -41.9162 -7.49401 17.923 -5356 4 12.213 3.67486 38.0016 27.2031 5.98064 4.05536 -5357 4 12.5797 5.11915 38.3509 20.8388 -3.72048 -10.4757 -5358 6 38.3368 5.25882 18.4553 -27.9454 13.7946 -11.1943 -5359 4 37.494 5.12162 18.8921 -4.17763 4.09508 -3.9191 -5360 4 38.9486 5.03087 19.1262 32.9808 -9.34357 19.7422 -5361 6 10.4991 9.23341 21.7308 -20.3579 1.12747 21.1104 -5362 4 10.1476 9.35811 22.629 -2.53412 -6.58654 -7.03761 -5363 4 11.4429 9.27697 21.8681 13.0367 -0.194449 -11.5952 -5364 6 0.510441 41.039 17.3204 -22.411 45.8537 -1.19125 -5365 4 1.10275 40.3438 17.515 21.9532 -27.5034 12.6219 -5366 4 0.955429 41.8901 17.5577 -0.403404 -22.4144 -8.21181 -5367 6 4.11028 5.06714 6.43108 -32.0559 -10.673 -25.0156 -5368 4 4.76196 4.43778 6.68194 21.2279 -22.0503 -6.17775 -5369 4 4.3376 5.79555 6.94869 8.69612 42.0455 26.6358 -5370 6 11.4527 25.4042 0.173069 -8.87291 20.1751 -4.43043 -5371 4 11.3037 26.302 0.51034 -2.48968 -2.12098 1.34892 -5372 4 12.3912 25.256 0.330533 -7.09022 -12.0676 2.67745 -5373 6 7.43008 21.5598 8.10589 6.84767 -16.7382 -30.018 -5374 4 7.67559 21.2373 7.18738 -12.1375 12.6211 33.8068 -5375 4 8.24892 21.8626 8.52003 -6.07298 -1.72571 -6.46698 -5376 6 47.5896 16.3642 25.2431 -28.5582 13.6976 -25.6498 -5377 4 46.6075 16.1608 25.1822 37.2389 5.55574 -4.66364 -5378 4 47.8562 16.8152 24.3682 -3.16196 -14.4146 40.515 -5379 6 30.9292 19.5125 39.8483 -41.4217 8.94898 -20.4144 -5380 4 31.859 19.4188 40.0164 22.9308 8.40553 1.58818 -5381 4 30.7224 20.3633 39.3589 16.5857 -27.3682 15.8932 -5382 6 20.3871 24.0387 39.4036 8.00795 23.2793 -8.75093 -5383 4 19.459 24.1701 39.2693 -20.2994 13.2523 2.58474 -5384 4 20.4244 23.1071 39.4874 5.50164 -36.2952 5.14995 -5385 6 45.8871 21.2471 41.1655 20.5283 25.7578 0.477301 -5386 4 46.6385 21.2626 41.7552 1.12624 -15.6366 20.1575 -5387 4 46.1812 21.9667 40.5962 -14.858 0.0662744 -14.6758 -5388 6 32.5732 28.1983 30.4559 17.8923 -19.7368 14.2663 -5389 4 32.9661 27.3096 30.6426 -14.7491 22.8943 -8.37245 -5390 4 33.2232 28.8091 30.8453 -8.57676 -1.81844 -4.53088 -5391 6 18.0207 1.32021 27.0363 -34.7874 1.53884 20.0911 -5392 4 17.0721 1.60205 27.1202 27.3864 -5.2263 -11.315 -5393 4 18.3294 1.50373 27.9381 11.4124 1.84961 -11.8648 -5394 6 39.378 24.9761 21.8758 -21.83 -3.15726 3.51608 -5395 4 39.2925 25.9351 21.9975 13.0773 -1.30024 -1.60914 -5396 4 38.5262 24.6687 22.2439 10.6836 3.42961 -4.87158 -5397 6 33.5904 21.3057 22.0908 0.876878 23.3779 1.34154 -5398 4 32.7037 21.4589 21.7601 -6.64994 -10.6299 -4.35651 -5399 4 34.0298 22.1428 21.8479 4.87062 -13.8873 3.79153 -5400 6 40.1162 15.0006 15.7553 -16.7667 -72.1851 -56.1125 -5401 4 39.3246 14.5665 15.2764 38.6699 22.9899 20.5541 -5402 4 39.7685 15.7046 16.224 -23.0828 51.553 35.6364 -5403 6 32.7063 17.9241 6.36312 -6.65812 28.0098 -27.693 -5404 4 32.6631 17.3286 7.08836 -4.96405 -26.2659 23.6138 -5405 4 32.2202 17.5402 5.61621 0.349997 -9.22032 2.43078 -5406 6 50.4717 15.9308 31.1336 -57.0185 -34.1342 43.3708 -5407 4 51.2677 16.1483 30.7347 55.5832 16.4654 -29.6643 -5408 4 50.5499 15.0059 31.4683 -2.42192 20.1529 -11.8828 -5409 6 23.8292 29.3322 31.6407 10.3974 -8.56959 5.42825 -5410 4 23.7096 29.6981 30.7618 4.3803 -0.813234 -2.10966 -5411 4 24.6813 28.8378 31.6594 -15.3785 13.3689 -4.34977 -5412 6 25.0524 41.6477 38.2806 4.00174 7.46449 -31.3583 -5413 4 25.6511 41.367 37.5454 -10.3054 -0.491554 23.0497 -5414 4 24.5276 0.474703 37.8884 8.98972 -6.87862 14.9811 -5415 6 14.3299 25.4693 7.99598 -51.8246 -23.5651 26.6357 -5416 4 15.0301 25.7523 7.4663 39.147 18.3395 -31.3738 -5417 4 13.6749 25.0466 7.38907 19.2382 9.49844 7.52052 -5418 6 17.2117 20.7467 5.34291 -12.6959 30.9635 29.5807 -5419 4 17.5658 20.2645 4.6512 13.3362 -42.6322 -45.6451 -5420 4 17.6752 21.5763 5.21476 -4.76461 12.1014 12.8322 -5421 6 18.8578 10.961 23.7113 11.9098 -52.6755 14.4862 -5422 4 18.5821 10.3312 23.0139 -2.7304 18.9854 0.947207 -5423 4 18.7069 11.8432 23.4586 -8.32501 34.3086 -18.4054 -5424 6 7.80658 41.3805 11.0401 -9.04392 11.0606 6.15122 -5425 4 8.00429 40.5098 11.4059 2.67644 4.01258 -4.23655 -5426 4 8.51691 0.066 11.3394 -1.81513 -7.16892 -1.05394 -5427 6 48.6966 23.1832 34.0648 -27.3561 -6.76338 -18.0805 -5428 4 48.0792 22.9132 33.32 19.6766 11.2437 24.8207 -5429 4 49.5669 23.23 33.6693 11.2336 0.854645 -6.12438 -5430 6 53.7246 23.5588 15.3422 -2.2993 4.88061 -38.5045 -5431 4 54.0115 23.9686 14.4981 1.04624 9.96871 20.6807 -5432 4 53.2132 22.8493 14.9574 -7.54922 -9.79714 16.7607 -5433 6 22.2409 5.63035 9.83732 -4.74687 0.990813 -28.4051 -5434 4 21.8007 4.9012 9.36518 5.41421 2.33681 17.3637 -5435 4 22.5704 6.16354 9.07597 -3.08255 -9.23766 25.1176 -5436 6 33.6677 8.38805 9.07277 4.65141 2.45263 2.68713 -5437 4 32.9476 8.96499 9.32099 -11.143 10.7473 10.4723 -5438 4 33.4213 8.08448 8.2012 2.38155 -0.0587928 -10.5973 -5439 6 47.3188 37.7205 20.3441 15.215 11.7573 -25.0114 -5440 4 47.5704 37.5879 19.4187 8.2864 3.06637 8.88956 -5441 4 46.6261 37.0853 20.3703 -21.7602 -22.9037 19.9419 -5442 6 30.8605 16.7391 10.6102 -28.0995 -48.2853 23.2284 -5443 4 30.4428 17.1675 11.4048 8.00556 -5.70758 -17.8294 -5444 4 30.5213 15.7576 10.5828 6.17084 54.1408 -3.58748 -5445 6 48.1227 27.723 10.1192 -17.271 38.6552 19.8549 -5446 4 48.941 27.5885 10.6019 15.4404 -6.10886 -7.64033 -5447 4 47.9667 27.1056 9.42146 1.69339 -23.2576 -13.9441 -5448 6 27.3465 38.6397 25.5972 -19.3603 -43.7567 25.3821 -5449 4 28.2552 38.3171 25.6348 3.73027 6.4174 -6.06634 -5450 4 27.3175 39.4354 25.1025 9.7616 28.5552 -11.1584 -5451 6 33.3485 5.72785 21.4502 -30.5322 15.1217 -10.2054 -5452 4 32.7106 6.21453 20.8566 24.3968 -18.0484 15.2917 -5453 4 34.2142 6.02589 21.2258 21.3261 10.3595 -12.9949 -5454 6 25.3097 5.14436 4.52462 -12.6707 -6.42781 10.7366 -5455 4 25.8166 5.03621 5.34324 9.24373 -0.000563512 -7.52253 -5456 4 24.4109 4.89546 4.80865 9.45245 1.955 -8.20101 -5457 6 40.4804 35.6472 19.1595 -4.18239 -17.2552 -25.1441 -5458 4 40.6473 35.1871 19.989 -0.677015 6.66802 10.9293 -5459 4 40.3876 36.5867 19.2889 2.08163 9.85771 9.62751 -5460 6 49.6466 30.6357 19.0258 14.8172 21.4531 -43.5404 -5461 4 50.0494 29.991 18.4245 -6.82309 -11.6442 2.45506 -5462 4 49.4912 30.1943 19.8303 -8.11919 -24.8089 39.0949 -5463 6 42.1414 28.3198 17.0336 30.9261 -8.96587 16.5499 -5464 4 41.9014 28.1134 16.1233 0.612516 -1.09878 -6.61247 -5465 4 42.9986 27.8356 17.2327 -32.0588 11.6021 -17.9905 -5466 6 47.7009 24.529 36.3602 12.6164 -10.6945 -29.4467 -5467 4 46.9511 23.9476 36.4057 -12.614 -6.01445 14.1932 -5468 4 48.02 24.3175 35.4647 6.89481 1.31964 6.68358 -5469 6 19.3487 26.9773 19.8132 -7.91098 29.1703 -3.69101 -5470 4 19.5772 26.0513 19.7652 -2.42994 -17.6971 2.90599 -5471 4 18.7132 27.1892 20.5145 5.94626 -13.5516 -3.80193 -5472 6 47.0594 26.8038 37.5124 29.171 -27.35 55.5912 -5473 4 46.5442 27.3901 37.0243 -28.7601 35.2651 -40.4696 -5474 4 47.4575 26.1126 36.9775 -8.83233 1.8809 -11.4479 -5475 6 9.306 24.6801 40.2841 31.4937 0.109789 0.329283 -5476 4 9.78189 23.9102 39.8717 -14.0424 16.7407 17.3327 -5477 4 10.0272 25.2082 40.7306 -19.6308 -16.1327 -14.1874 -5478 6 14.4855 17.9139 14.2735 23.8217 -2.3356 -5.96097 -5479 4 13.7756 18.1909 13.6871 -0.445295 3.10639 3.20472 -5480 4 15.2926 17.8532 13.6969 -24.9099 1.36359 15.4275 -5481 6 37.1333 38.6708 18.7289 9.24178 15.507 -32.6939 -5482 4 36.7257 39.5382 18.5851 -4.02817 -0.227247 6.07181 -5483 4 37.6697 38.5833 17.9067 -2.91955 -11.3843 16.172 -5484 6 11.4153 5.92336 21.4477 15.4675 -15.5323 24.3843 -5485 4 12.0347 5.46444 22.0611 -14.8481 11.1792 -11.8992 -5486 4 10.9828 5.22117 20.955 -5.02219 -4.37746 -7.57367 -5487 6 4.24672 30.7112 16.2271 25.0754 -37.7862 10.5022 -5488 4 4.05441 31.4608 15.7204 -4.71706 34.9582 -31.1175 -5489 4 3.72964 30.8334 16.9988 -11.892 -2.06994 24.4228 -5490 6 17.6689 16.0105 27.0706 -11.532 -19.4613 -16.5334 -5491 4 17.475 15.0322 27.0999 0.550485 29.0366 -12.0979 -5492 4 17.2014 16.3875 26.2691 10.8221 -16.0252 20.0561 -5493 6 36.4979 8.6445 40.4253 22.1182 5.90925 -1.87084 -5494 4 36.6649 9.56092 40.6574 -3.64727 2.10984 0.486612 -5495 4 35.6642 8.36755 40.7885 -12.5441 -1.64485 2.44437 -5496 6 13.6104 12.9476 3.01337 -0.796658 -1.76047 52.4558 -5497 4 13.281 12.534 3.85665 2.0295 3.09436 -35.1239 -5498 4 14.3672 13.4568 3.35498 1.79634 -1.71495 -16.7359 -5499 6 38.5663 20.1511 21.6276 16.2684 -2.59448 10.3838 -5500 4 39.225 20.3435 20.957 3.66548 0.723189 -1.42015 -5501 4 37.7399 20.1987 21.178 -26.4348 -4.9091 -11.1397 -5502 6 51.0002 10.2707 30.836 -20.0759 -41.5967 21.7358 -5503 4 51.4945 11.0341 30.626 15.2265 30.1997 -10.6067 -5504 4 50.365 10.1656 30.1217 2.42758 1.75416 -9.76943 -5505 6 16.2768 2.44039 41.3342 24.5898 23.894 -47.9169 -5506 4 15.7659 1.68969 41.4668 -26.4768 -52.1654 31.458 -5507 4 16.2309 2.46185 40.3616 9.12406 8.41144 7.6857 -5508 6 16.5823 4.96192 41.8916 -4.82165 52.2801 -70.6027 -5509 4 16.7504 4.9538 0.881833 10.2709 -3.72182 62.3109 -5510 4 16.3825 4.09214 41.6138 -6.48385 -26.7637 5.90228 -5511 6 38.2132 37.6512 20.9834 35.6931 -0.0015793 9.16781 -5512 4 38.1132 38.2158 20.1985 1.71026 -5.63736 5.42755 -5513 4 39.175 37.679 21.2752 -35.8773 5.52261 -11.9395 -5514 6 27.3063 1.90932 15.7743 -36.1781 7.04456 22.02 -5515 4 27.5288 1.21363 15.1745 3.62804 -9.29946 -19.0329 -5516 4 26.3092 1.89423 15.8276 27.8398 0.929522 -3.41863 -5517 6 29.0129 12.4346 37.8081 29.6396 -2.3639 23.3235 -5518 4 29.5703 13.228 37.8521 -9.25731 3.38449 -11.2245 -5519 4 29.432 11.8866 38.5178 -20.735 6.92768 -10.3763 -5520 6 46.0725 20.1624 18.9069 6.39102 14.9163 -14.6323 -5521 4 45.1723 20.516 18.8892 1.91785 -0.379773 0.405435 -5522 4 46.587 20.7656 18.3221 -3.54001 -13.7442 9.74416 -5523 6 2.03634 38.6845 18.4933 3.82981 -3.85695 21.6638 -5524 4 2.81563 38.6864 19.0472 23.4807 10.2435 -12.678 -5525 4 1.45125 38.3557 19.1766 -27.1945 -1.99387 -8.3623 -5526 6 44.0469 24.9707 25.966 7.80173 10.6441 20.9452 -5527 4 44.2747 24.0363 26.0952 1.37736 2.33249 -4.33209 -5528 4 43.5784 25.0701 25.1359 -3.49858 -7.6437 -6.59112 -5529 6 5.98346 26.6137 4.53144 23.0758 4.04073 24.4329 -5530 4 6.55391 27.1627 5.13089 -15.1794 -12.3526 -15.6845 -5531 4 6.29729 25.6938 4.67268 -13.7287 18.2257 -9.78447 -5532 6 0.087877 23.2081 10.934 24.9145 3.46447 1.10559 -5533 4 0.685292 23.7315 10.3726 -8.08066 -2.01306 3.92681 -5534 4 0.721975 22.7627 11.5282 -19.4067 -0.934622 -1.78644 -5535 6 39.1228 20.6282 12.8796 23.5823 -4.01912 3.74068 -5536 4 40.0483 20.9095 13.1274 -25.2182 -11.8294 -4.75086 -5537 4 38.9288 21.0058 12.0111 3.51405 8.21934 1.48951 -5538 6 39.9585 39.9542 18.8548 8.25477 7.63818 -34.14 -5539 4 39.6086 40.5348 18.1328 12.8912 -23.3113 16.3656 -5540 4 39.4227 40.1355 19.596 -22.4924 5.25798 25.9214 -5541 6 49.2764 23.011 30.5163 -3.77364 -44.6036 15.8547 -5542 4 49.4289 23.7872 30.0082 18.6126 30.182 -14.9565 -5543 4 49.9621 22.8706 31.1946 3.66181 18.5012 -4.70792 -5544 6 10.3518 2.34263 9.13761 -0.60969 70.0656 33.4022 -5545 4 10.2194 1.51752 8.76453 -19.3013 -48.5596 -30.1763 -5546 4 9.57958 2.95755 9.02478 16.8019 -18.7251 -1.57756 -5547 6 9.61453 40.9339 19.7468 19.8516 -54.9951 -16.0575 -5548 4 9.63195 40.6865 18.7859 0.317082 16.3896 20.6195 -5549 4 10.0376 40.0904 20.1458 -24.9194 43.0231 -10.2629 -5550 6 29.2525 5.10109 17.4961 7.67774 22.6856 2.90325 -5551 4 29.0408 4.77134 16.6193 -6.82779 -3.03985 -6.7526 -5552 4 29.5295 6.02934 17.3335 -2.58265 -16.5067 4.76001 -5553 6 27.0985 15.4102 3.23556 -13.4453 -81.1273 -7.3603 -5554 4 27.3652 16.2806 3.27349 18.8182 67.1491 11.283 -5555 4 27.7776 14.8512 3.68225 -14.3437 21.6428 -0.863725 -5556 6 32.8444 39.3852 25.121 -7.01244 -52.8845 44.4676 -5557 4 32.5131 40.2222 24.9368 -10.8075 51.8916 -16.2411 -5558 4 32.4445 39.2315 26.0289 16.1191 -0.874654 -30.671 -5559 6 34.9513 7.88207 31.2328 20.4504 58.5219 2.42802 -5560 4 34.2036 8.45679 31.498 3.65199 -12.2289 -1.35309 -5561 4 34.6861 6.99719 31.2488 -20.0023 -44.0519 1.25651 -5562 6 6.12467 36.7605 26.1486 23.5936 30.152 20.8626 -5563 4 6.61267 37.4751 26.6609 -18.7565 -29.2185 -15.3031 -5564 4 6.64666 36.6639 25.3566 0.873799 -8.15108 -9.63468 -5565 6 6.01736 25.8242 24.1032 -23.71 11.4997 43.6127 -5566 4 6.27054 25.4519 24.9889 5.69321 0.899098 -34.3464 -5567 4 5.25039 26.3671 24.4036 11.002 -12.3451 -22.9516 -5568 6 45.616 24.3868 2.54557 6.93899 11.9467 -1.18645 -5569 4 46.5025 24.2318 2.18535 0.269069 -11.0786 2.08994 -5570 4 45.6283 24.2142 3.48441 5.93067 -6.10702 12.3332 -5571 6 15.5106 11.7053 32.6869 22.7313 15.5035 25.4621 -5572 4 15.7644 12.551 33.1413 -9.31293 -24.2108 -12.4541 -5573 4 14.956 11.9719 31.9681 -12.2379 8.7831 -14.7046 -5574 6 46.4141 17.7037 37.4783 -24.8433 -42.9552 -46.1347 -5575 4 46.5841 17.8832 38.3706 6.4658 9.03355 44.3658 -5576 4 46.0203 16.778 37.4148 6.08678 36.5836 2.96135 -5577 6 39.713 20.917 18.528 13.2313 30.5311 40.8197 -5578 4 40.433 20.5782 18.0298 13.2747 -18.0123 -24.5712 -5579 4 40.2054 21.5165 19.1543 -30.2447 -12.7963 -15.6911 -5580 6 23.8051 28.0334 36.6648 -18.7533 17.1228 48.8478 -5581 4 23.301 27.37 37.1661 8.15196 -5.41595 -20.5023 -5582 4 23.699 28.7533 37.3439 14.557 -4.10395 -29.4534 -5583 6 23.235 0.659798 30.8906 16.7198 -34.3804 0.301059 -5584 4 23.3562 41.8891 31.5781 -2.93034 5.1259 -1.85649 -5585 4 23.9222 0.433479 30.2226 -16.4688 10.6885 3.12481 -5586 6 37.1438 6.89027 28.2945 -2.75708 2.50278 32.0481 -5587 4 36.7625 6.23385 28.9496 14.7229 22.3106 -21.8828 -5588 4 37.4874 7.65333 28.8474 -13.0775 -21.14 -18.6628 -5589 6 3.23769 6.61111 12.3846 0.723209 -17.9385 -9.61551 -5590 4 2.93962 6.7917 11.4726 6.04883 11.0603 10.3219 -5591 4 3.59705 5.70622 12.3141 -7.8292 10.6871 9.81534 -5592 6 12.6213 19.1513 31.1215 -11.7593 -39.2703 -9.13055 -5593 4 12.5689 18.1911 31.4279 4.41954 36.1073 -0.401864 -5594 4 12.3049 19.0952 30.1995 4.23471 8.33584 13.9505 -5595 6 15.1895 38.3194 41.5508 -8.26313 0.106571 5.96729 -5596 4 15.4027 38.685 40.6867 1.58925 3.7734 1.08261 -5597 4 15.977 37.8419 41.8199 8.82113 -1.67422 -0.112624 -5598 6 49.6344 33.3417 19.6414 -43.1776 -42.2962 -0.847743 -5599 4 48.6794 33.3996 19.9697 35.2792 3.84356 -17.7841 -5600 4 49.66 32.3974 19.2778 11.8172 40.1309 17.1575 -5601 6 6.36572 2.78375 29.9004 1.05055 15.8156 -22.8281 -5602 4 6.36575 3.75042 29.7262 1.90425 -15.9719 7.25575 -5603 4 5.96593 2.68858 30.7619 0.24665 -4.47807 16.8647 -5604 6 13.1696 31.768 30.2754 -6.44409 10.1839 -14.6274 -5605 4 12.7931 32.0108 29.386 8.00869 -8.49993 19.6421 -5606 4 12.9985 30.8211 30.4317 -1.17466 7.15103 -3.10169 -5607 6 32.315 32.2433 24.9103 28.3535 -13.0924 -48.465 -5608 4 32.6582 31.5201 24.3183 -18.8106 4.4732 28.5514 -5609 4 32.6906 33.004 24.4312 -3.21058 9.63112 20.1287 -5610 6 42.0003 14.5628 37.421 -39.889 12.6212 -8.37855 -5611 4 41.095 14.1415 37.3281 37.9102 -1.96214 -0.320241 -5612 4 42.7025 13.9066 37.3517 -4.02931 -15.6388 2.60245 -5613 6 11.8892 7.23447 27.6701 3.45884 -4.12236 4.5236 -5614 4 11.8415 6.40302 28.2109 -4.80024 17.2153 -14.4092 -5615 4 11.297 7.16355 26.8983 -0.411327 -9.99206 8.34553 -5616 6 14.2054 37.5349 6.88535 -5.50304 -50.1586 -23.8091 -5617 4 14.4448 38.4425 6.82842 11.1201 34.2121 -5.16838 -5618 4 14.5404 37.0855 6.04727 -8.45912 19.5264 31.302 -5619 6 14.2389 30.7101 36.0658 7.9951 22.3707 -6.00421 -5620 4 14.3369 30.7582 35.119 5.20948 5.89711 -15.5268 -5621 4 14.162 29.7856 36.1796 -2.50712 -40.828 17.27 -5622 6 16.4199 33.6465 5.49971 39.8982 -12.4718 -37.0106 -5623 4 16.8881 34.472 5.38053 -10.1033 13.7438 12.8324 -5624 4 16.9383 33.116 4.82328 -31.4907 -2.1142 22.2677 -5625 6 23.0347 17.1509 7.84843 -2.98061 53.305 10.417 -5626 4 22.2528 17.4913 7.37616 0.35347 -20.1342 1.7373 -5627 4 23.3535 18.0122 8.2624 2.91922 -40.8936 -9.01863 -5628 6 51.739 20.8998 27.7117 45.1346 -9.91933 19.8422 -5629 4 51.4539 20.5938 28.5983 0.576611 5.87017 -14.8878 -5630 4 52.7517 20.9693 27.7878 -43.3794 -0.870523 -11.1135 -5631 6 2.19386 27.6013 28.8077 21.9852 1.77593 -20.6905 -5632 4 2.90112 28.2633 28.7865 -8.94698 7.25322 21.5481 -5633 4 2.57794 26.9939 28.1568 -21.2327 -10.3447 8.82052 -5634 6 17.2209 14.3445 7.70498 -9.6153 -40.0176 25.3709 -5635 4 16.7414 14.2178 8.5755 19.2823 5.01031 -25.0594 -5636 4 17.7242 13.4894 7.54274 -12.7499 32.9606 1.11211 -5637 6 12.4553 8.94194 14.7093 23.4905 -30.5738 22.1451 -5638 4 12.3295 7.96561 14.6517 -10.6336 18.1935 -14.5798 -5639 4 13.0902 8.95069 15.466 -13.8235 22.031 -14.7981 -5640 6 42.4163 38.0607 9.75492 -41.3892 12.3524 0.930734 -5641 4 43.2155 37.8504 10.1985 23.5031 -2.65638 19.8551 -5642 4 41.8128 38.5249 10.3845 19.1619 -5.0707 -9.72644 -5643 6 51.8291 30.3524 28.2725 -23.4976 -15.3182 24.0858 -5644 4 51.4769 31.1806 28.0071 -16.9091 20.9854 -6.54852 -5645 4 52.5669 30.2698 27.7075 37.0459 -10.0857 -13.876 -5646 6 0.173291 18.5306 4.58887 -6.78508 26.3933 6.63194 -5647 4 0.366643 18.0957 3.77581 2.61413 -8.62723 -27.1515 -5648 4 0.528197 17.9664 5.25604 0.668563 -20.2899 17.5992 -5649 6 34.1542 0.618182 3.01035 -64.6642 7.59467 -29.5426 -5650 4 33.2756 0.91071 2.55681 38.9521 -14.8268 28.0312 -5651 4 34.8139 1.0189 2.46529 20.392 14.9436 -5.19898 -5652 6 49.1703 17.2445 23.163 11.3421 -28.7232 -23.3687 -5653 4 50.0948 17.5226 22.997 -11.4987 -1.8789 7.34388 -5654 4 49.1149 16.3391 22.7575 3.35316 27.0342 8.27414 -5655 6 23.1508 6.50484 23.6205 15.3745 23.1125 -33.0506 -5656 4 23.1854 7.14565 22.8174 -14.1016 -25.0292 28.8988 -5657 4 22.2566 6.27815 23.8868 -11.3625 11.3028 -1.57795 -5658 6 11.0777 24.0866 29.2726 3.42799 -14.5151 -26.2344 -5659 4 11.3051 23.4915 28.5104 -10.7193 12.1306 15.2701 -5660 4 11.7189 23.8646 29.9475 6.00027 1.59973 10.1126 -5661 6 36.5499 4.08922 21.6769 -9.80126 5.87302 -21.3361 -5662 4 36.3976 4.50823 22.521 3.21878 -0.144303 13.033 -5663 4 36.3054 4.80832 21.0596 6.63301 -13.9203 1.83546 -5664 6 31.3023 25.6432 24.5943 15.0376 6.85795 28.0728 -5665 4 31.291 26.2789 25.3519 -12.6017 -14.5788 -25.478 -5666 4 32.0941 25.1064 24.7955 -9.59576 -0.449362 -7.93794 -5667 6 42.6065 23.029 14.7662 -46.2562 -12.0705 -53.1337 -5668 4 42.8654 23.3474 13.8766 8.33796 6.77145 13.2285 -5669 4 43.1929 23.285 15.4255 44.8404 21.8098 38.991 -5670 6 14.3111 11.6689 8.88632 -19.0153 -23.9468 -21.906 -5671 4 13.3495 11.3817 8.87766 31.9146 14.5471 0.24728 -5672 4 14.742 11.0378 8.25313 -7.14597 12.5116 20.7778 -5673 6 21.4992 2.13393 3.40246 8.36864 -2.88126 -9.61958 -5674 4 22.4231 2.22963 3.69686 -12.58 -3.45743 -2.69439 -5675 4 21.4721 1.34946 2.81138 2.62282 6.56171 18.4043 -5676 6 22.4667 27.6841 39.0793 -16.1771 -11.2193 -33.3168 -5677 4 22.9487 28.2311 39.6723 13.8114 13.1168 21.0188 -5678 4 22.2331 26.8853 39.529 -0.753476 -8.75647 11.2468 -5679 6 37.2752 33.5075 30.0534 -5.09816 -29.8969 21.2662 -5680 4 36.5321 32.9121 30.2938 11.1992 13.6878 -5.37502 -5681 4 38.0391 33.1092 30.5204 -9.59535 7.6329 -11.7718 -5682 6 41.8356 20.8755 40.0084 -30.1785 -26.2846 -15.3963 -5683 4 40.891 20.6843 40.2338 21.7839 7.55089 -6.55796 -5684 4 42.213 21.2736 40.7728 12.4306 8.07023 23.0746 -5685 6 10.0585 31.1051 22.2503 24.8691 -18.1602 32.094 -5686 4 10.0242 30.9652 23.2199 -0.323131 -4.21186 -18.2592 -5687 4 9.26251 31.5457 22.0526 -32.5358 14.9165 -12.561 -5688 6 24.2061 35.3797 6.65176 29.8647 -7.74501 -52.0461 -5689 4 23.2981 35.13 6.46942 -12.5131 3.59528 11.7489 -5690 4 24.436 35.6291 7.5325 -13.5066 3.92126 26.0938 -5691 6 54.2205 13.3707 18.7548 -14.8606 0.23157 2.49876 -5692 4 53.5905 13.2954 18.0026 12.0308 5.79113 16.3195 -5693 4 53.7072 13.5032 19.578 4.97112 -2.65932 -16.1217 -5694 6 12.4895 25.0856 17.4479 -5.54126 21.12 19.6166 -5695 4 12.0527 25.8035 17.9613 1.96295 -15.4272 -10.9144 -5696 4 12.9797 24.5872 18.1192 -7.22993 -2.38631 -13.5888 -5697 6 22.3914 33.9622 18.8899 -17.7941 -3.8788 -25.186 -5698 4 22.7777 34.3519 18.0802 1.20341 3.55679 12.7761 -5699 4 21.5828 33.5138 18.532 26.0363 5.82114 13.25 -5700 6 24.4442 12.917 5.83205 -1.35281 -9.13891 6.68087 -5701 4 24.5112 13.8355 6.04562 11.139 23.8521 5.95609 -5702 4 23.7978 12.9208 5.12829 -4.38592 -8.75699 -5.70796 -5703 6 13.4045 11.2384 28.602 -9.94106 -32.5269 -0.345522 -5704 4 13.7125 10.4202 28.1467 1.06973 22.7078 1.68844 -5705 4 12.6883 10.856 29.1417 2.50959 12.0169 -5.49025 -5706 6 20.9681 34.6931 21.1354 15.1203 14.42 -6.16036 -5707 4 21.5009 35.1121 21.8248 -8.94458 -7.77672 4.1779 -5708 4 21.5063 34.8208 20.3262 -11.2236 -10.4562 8.09593 -5709 6 37.1336 34.5207 26.1541 -9.5297 -36.7224 -3.07541 -5710 4 37.2109 34.2142 25.2288 3.21082 15.1766 11.7274 -5711 4 37.5352 35.3664 26.2639 8.9577 18.3348 -6.65469 -5712 6 49.3622 27.1182 23.4746 39.7066 -11.0301 13.9767 -5713 4 48.4746 27.3502 23.3119 -43.65 9.96054 -8.06751 -5714 4 49.6716 26.7458 22.6451 -3.30563 -9.15784 -7.68388 -5715 6 2.6564 41.733 27.6477 -1.65257 -10.3676 0.180548 -5716 4 2.5349 41.5868 26.6785 2.71482 14.5166 10.808 -5717 4 3.44733 0.360291 27.8573 -13.8821 -2.9337 -13.5775 -5718 6 28.2538 5.65865 0.855763 -50.2522 -11.1502 7.99105 -5719 4 29.1126 5.92525 0.635025 43.8938 8.11388 -11.2713 -5720 4 28.2366 4.68907 0.832778 5.05155 4.08711 2.73992 -5721 6 46.3376 19.9476 30.6448 -5.32264 7.02196 22.3264 -5722 4 46.9473 19.8004 29.9179 3.84913 9.17517 -5.42643 -5723 4 46.6125 20.7672 31.1318 -5.12963 -19.3092 -16.4827 -5724 6 3.64577 25.7701 21.5553 -12.766 27.4814 -12.397 -5725 4 3.72382 24.8593 21.8343 3.84868 -9.88757 -5.52558 -5726 4 3.13913 25.8588 20.7173 13.2009 -15.3518 9.10855 -5727 6 2.75122 19.0968 29.6319 -2.61118 -0.882922 8.96218 -5728 4 3.5891 18.6871 29.8565 3.14038 -9.81989 10.1431 -5729 4 2.90737 19.4327 28.7602 3.1882 14.1904 -12.7773 -5730 6 11.8953 35.7778 24.2646 -23.8517 23.4638 0.926703 -5731 4 12.2722 34.9198 24.2954 23.5909 -23.1933 0.784725 -5732 4 12.5229 36.3761 23.8548 12.2449 3.68762 -3.83655 -5733 6 52.3409 30.3775 14.3038 25.9342 24.3497 3.27132 -5734 4 52.8186 31.1218 14.7277 1.28259 -10.3571 -1.87569 -5735 4 51.5459 30.7912 14.0165 -25.7225 7.74731 -5.34623 -5736 6 0.083662 24.3704 32.1159 7.87696 -1.86575 0.949534 -5737 4 0.925887 24.7254 31.8116 -7.58302 1.2158 -10.0766 -5738 4 0.064605 24.6797 33.0182 -11.6947 5.89195 12.8097 -5739 6 31.4941 23.7355 38.8139 13.6067 4.55671 22.3988 -5740 4 31.5922 23.3599 39.6955 6.6148 17.5079 8.63317 -5741 4 30.9989 23.0266 38.4646 -21.4094 -18.5611 -29.2329 -5742 6 52.1193 21.6104 3.49599 14.6151 -31.0847 -13.388 -5743 4 52.9641 21.5934 2.99085 -20.8635 4.42776 5.19501 -5744 4 52.1025 22.4297 3.95509 1.85636 27.8943 8.87727 -5745 6 31.7523 33.9412 11.6017 9.59211 -24.6365 -8.99112 -5746 4 31.343 34.2459 12.4067 -7.95657 10.1636 10.9534 -5747 4 32.0734 33.0348 11.7994 -4.73133 20.193 -2.42319 -5748 6 7.03486 17.6719 16.6685 29.0057 -41.5114 -49.367 -5749 4 6.91092 17.0215 17.3537 -7.78637 4.64801 28.8113 -5750 4 7.29826 17.0034 15.9319 -18.9591 50.1453 28.7374 -5751 6 51.8542 41.8728 22.1898 10.246 17.2442 -13.5357 -5752 4 52.3028 41.4443 22.9054 19.3182 -6.61148 18.5368 -5753 4 51.1068 41.3135 22.0792 -27.0964 -11.4612 -2.03348 -5754 6 50.8737 9.93347 25.9376 -32.929 -21.31 0.307119 -5755 4 50.6075 10.0984 25.0351 -2.54905 2.45869 -5.94774 -5756 4 51.7134 10.3221 26.0527 29.2363 20.0336 5.9403 -5757 6 9.00178 39.8723 13.8451 -19.3622 -18.1235 -30.983 -5758 4 9.55792 39.3182 14.3856 9.60602 -5.37935 8.26515 -5759 4 8.70771 39.29 13.0873 14.4347 20.6992 23.854 -5760 6 40.6986 25.5526 0.136544 19.9096 -17.3535 33.0343 -5761 4 40.3666 25.3638 1.04053 0.834228 7.76146 -13.9079 -5762 4 41.6521 25.7245 0.296606 -16.7956 -8.725 -14.7957 -5763 6 46.6823 7.83196 22.8561 10.1499 25.8504 33.9562 -5764 4 46.2788 7.49308 23.6743 -2.78909 -8.0392 -13.1915 -5765 4 47.099 8.65892 23.1926 -4.50937 -8.82075 -14.1875 -5766 6 20.9875 12.9068 9.95805 -11.691 32.2034 24.7109 -5767 4 21.4351 12.3054 10.5167 21.854 -26.8991 22.1196 -5768 4 21.3309 12.7465 9.11062 12.4417 -9.66517 -44.3579 -5769 6 24.8453 0.514421 28.6038 13.082 22.7197 -2.81433 -5770 4 24.715 0.071792 27.7548 -6.16819 -1.63374 -2.91335 -5771 4 25.0442 1.45997 28.4028 -6.72102 -19.281 3.08734 -5772 6 9.94041 22.6855 8.28517 -18.2906 18.759 -35.6321 -5773 4 10.3442 21.9586 7.83344 17.071 -18.1108 1.7387 -5774 4 9.60436 23.1702 7.48056 7.13277 7.40532 33.7222 -5775 6 33.2759 9.25429 23.8257 8.37106 -55.2845 13.9355 -5776 4 33.3237 10.1123 23.4806 -1.26345 47.1757 -20.4798 -5777 4 34.1087 8.81977 23.5578 -8.47821 6.16632 5.2483 -5778 6 47.7984 20.3614 34.2959 -41.6158 20.0741 -32.6301 -5779 4 47.162 20.9095 33.7523 35.4977 -6.5354 18.8426 -5780 4 47.2264 19.5923 34.4121 13.8381 -6.37745 11.1074 -5781 6 7.49292 13.4971 41.09 9.79805 -11.8131 -23.6679 -5782 4 7.49901 13.1324 40.1715 -6.0705 12.8605 17.5951 -5783 4 8.32745 13.1637 41.4633 -5.36906 3.36653 2.36319 -5784 6 9.96112 23.6102 1.61114 1.89646 0.256416 -8.05524 -5785 4 10.3422 24.1467 0.893187 3.70522 0.0162214 12.766 -5786 4 9.63217 22.8308 1.16111 -2.5861 -8.4474 -3.4617 -5787 6 27.3279 14.1675 11.3384 -16.3978 3.93745 18.7515 -5788 4 27.0565 14.7974 10.6584 -0.154384 0.736593 1.51299 -5789 4 26.9739 14.5213 12.1957 15.9081 -3.44829 -24.7787 -5790 6 25.8416 31.7729 17.8867 -18.6075 -57.137 -13.4601 -5791 4 26.5498 31.1652 17.5816 -7.88637 19.42 8.67928 -5792 4 26.1364 32.6121 18.1157 31.0786 47.9057 11.8145 -5793 6 28.5054 34.3394 0.220618 54.67 33.5077 11.5224 -5794 4 29.0324 33.8757 0.885908 -4.94848 -3.20805 0.921423 -5795 4 27.711 33.8992 0.092994 -46.8158 -31.9819 -6.78258 -5796 6 39.4821 27.6754 22.7241 37.6977 26.8974 -34.7457 -5797 4 38.562 27.8477 22.7631 -35.1425 8.51836 6.28403 -5798 4 39.8483 28.4606 22.2037 -4.4779 -30.5719 17.4824 -5799 6 19.3989 35.5068 37.6449 44.7238 7.00696 26.241 -5800 4 18.7939 34.9286 37.217 -17.2642 -20.3375 -13.2178 -5801 4 20.0787 34.9056 38.0699 -27.4009 15.1777 -18.4057 -5802 6 40.2622 30.2205 10.7395 23.7464 -4.20556 -44.2191 -5803 4 39.872 30.2327 11.5724 -12.5687 -7.32393 56.9787 -5804 4 39.6265 30.6987 10.2193 -5.46151 14.1383 -16.826 -5805 6 44.8252 28.4803 36.0885 -55.5401 -40.4399 48.4955 -5806 4 44.0914 27.9458 36.6324 49.8455 26.3412 -39.6007 -5807 4 44.7386 29.3482 36.4954 11.2485 4.05282 -13.3799 -5808 6 17.9305 13.9374 34.278 5.37655 43.1893 -39.9004 -5809 4 17.3503 14.7126 34.0365 12.4853 -29.216 13.3111 -5810 4 17.5732 13.4499 34.9957 -23.6035 -11.4222 25.4792 -5811 6 22.772 11.7897 25.9182 -5.92321 66.9234 -24.4623 -5812 4 22.4079 10.9608 26.1065 -2.80798 -46.2844 14.8143 -5813 4 23.7282 11.8442 25.9391 13.2658 -20.917 3.34216 -5814 6 27.9678 31.9745 40.3581 9.67064 -3.036 11.5355 -5815 4 28.3415 32.7469 39.952 3.83939 12.9153 -6.44865 -5816 4 27.8423 31.3481 39.6454 -9.64166 -7.41544 0.62615 -5817 6 29.7189 5.14175 29.7003 46.1252 -36.6163 -19.9261 -5818 4 29.2969 5.47215 30.4671 -15.8461 16.6952 32.1509 -5819 4 30.5834 4.69597 30.0017 -39.473 23.5261 -13.8417 -5820 6 3.10812 21.482 2.76797 0.178067 -30.2305 -7.76436 -5821 4 2.88389 22.394 2.68207 -8.68283 21.8462 0.431797 -5822 4 2.52465 20.9987 2.15107 4.11904 7.00085 10.9335 -5823 6 13.6455 30.6616 39.7413 -31.0251 6.24286 -53.6991 -5824 4 14.4958 30.9276 39.9901 40.59 7.52955 18.7737 -5825 4 13.6028 30.9637 38.7781 -13.7388 -14.6365 40.9566 -5826 6 39.1879 23.0833 28.2631 23.8153 34.0131 -40.8644 -5827 4 39.3603 23.1915 27.276 -9.32936 -4.03115 31.7012 -5828 4 38.6771 22.3028 28.3825 -19.3689 -24.2853 3.44718 -5829 6 16.9942 23.7475 0.782551 23.2332 -11.0525 -6.02825 -5830 4 16.1835 23.4907 1.22514 -0.204047 -3.07314 3.44284 -5831 4 17.6924 23.1245 1.11262 -18.9135 18.2649 -2.71213 -5832 6 0.34625 33.6655 13.0265 -29.0282 32.855 38.2597 -5833 4 54.9333 33.1158 13.7076 7.16186 -20.0974 -8.4449 -5834 4 0.196186 34.5312 13.5136 21.864 -23.0202 -35.8666 -5835 6 49.1134 40.6592 16.9502 -22.6074 7.13526 -12.7963 -5836 4 49.0929 41.0585 16.0481 9.95068 -10.3513 11.1088 -5837 4 48.1763 40.6949 17.2078 7.5264 3.31219 -3.37923 -5838 6 52.1371 39.9932 15.179 23.5783 8.13152 6.60826 -5839 4 51.9212 40.0798 16.1068 2.92809 -1.65288 7.91558 -5840 4 51.3496 39.6649 14.7978 -27.1925 -6.99882 -20.2103 -5841 6 29.0492 37.0934 37.8397 27.862 0.580994 -15.5106 -5842 4 29.7824 36.6456 38.29 -13.83 -0.942856 -3.03347 -5843 4 28.3401 37.1923 38.4583 -14.8343 8.34268 17.6028 -5844 6 4.87483 1.47389 27.5722 8.99005 1.78018 0.412076 -5845 4 5.18955 1.04652 26.7639 -2.94161 4.65408 6.15856 -5846 4 5.65876 1.67721 28.1054 -5.69693 -0.488114 1.02013 -5847 6 43.5905 24.3648 30.2005 -22.2044 -15.6763 19.9702 -5848 4 44.3573 23.9419 29.8442 19.8319 -9.6252 -11.3654 -5849 4 42.9995 23.6287 30.4468 4.54232 11.3491 -5.57307 -5850 6 33.7546 3.53169 22.9281 6.20171 -10.3572 -20.5792 -5851 4 34.1788 2.72522 22.5548 -7.61164 22.2296 6.95503 -5852 4 33.66 4.19918 22.2026 -0.715781 -19.232 19.3758 -5853 6 19.8847 13.4579 25.4063 -13.0952 -9.58357 -31.6265 -5854 4 20.5464 14.0819 25.6574 14.0517 10.8301 14.4774 -5855 4 19.8633 12.7253 26.0209 8.35596 -5.88238 10.9252 -5856 6 47.3765 23.175 39.6238 -8.62258 12.6683 8.16714 -5857 4 47.7656 22.5263 39.0394 4.03481 -11.1372 -12.2265 -5858 4 47.7314 24.026 39.3382 2.38196 -1.35255 2.76448 -5859 6 20.1792 18.6695 32.3892 10.8118 -11.8558 9.82813 -5860 4 19.7451 19.3837 31.9609 -18.6549 15.8768 -14.4176 -5861 4 21.1063 18.8885 32.2904 5.57481 -8.22146 4.6255 -5862 6 0.469489 5.80056 25.6694 -18.1951 25.8664 -34.3154 -5863 4 0.192512 6.63022 25.2132 12.4788 -26.9708 -4.90825 -5864 4 0.599388 6.15564 26.5295 8.98284 3.20038 34.2611 -5865 6 6.87796 19.5502 31.9212 -30.9469 28.3562 -15.4034 -5866 4 6.36899 19.9719 32.666 7.94508 -11.3044 -26.1662 -5867 4 6.51823 19.9652 31.058 21.1032 -17.2362 32.6466 -5868 6 6.72006 20.2763 38.5282 -5.5716 11.964 -18.9783 -5869 4 5.89143 20.7831 38.5761 11.8801 -4.42879 -4.55199 -5870 4 6.91977 20.0675 39.4366 -2.33705 -6.77268 4.9945 -5871 6 22.0131 25.9408 12.2669 -3.54377 -45.9259 -44.7125 -5872 4 21.4169 25.4251 11.6232 6.06411 36.0021 36.1209 -5873 4 22.8575 25.5519 12.0003 5.79029 4.70211 8.19546 -5874 6 39.2956 7.94468 2.64777 3.93347 -3.54621 1.69719 -5875 4 39.6192 7.96721 3.55942 2.89932 9.4301 1.57912 -5876 4 39.5223 7.0665 2.33247 5.57505 -8.53159 -3.65477 -5877 6 29.9733 22.0379 34.4029 6.80249 8.99144 -26.5663 -5878 4 30.9486 21.9114 34.4332 -22.6925 2.47334 -4.63229 -5879 4 29.7282 22.2324 33.4511 1.23467 -5.29722 31.1857 -5880 6 37.585 16.2896 0.378862 9.66072 -32.1652 -13.4334 -5881 4 37.1738 15.3958 0.469359 7.4986 19.6703 2.82788 -5882 4 38.3979 16.0784 41.7811 -5.81955 5.34443 7.8674 -5883 6 11.7199 13.8969 21.9024 0.976022 -4.28814 -52.9061 -5884 4 11.762 13.5091 20.9636 8.25344 3.74313 41.2159 -5885 4 11.7301 13.2111 22.5694 -0.197866 -18.3587 0.721586 -5886 6 33.3547 10.9227 27.6206 7.79028 2.98821 -12.2755 -5887 4 32.7398 11.5851 27.2614 8.9286 -8.03905 3.2582 -5888 4 34.0693 10.7866 26.9485 -19.1033 10.7299 13.3482 -5889 6 30.9479 36.5351 10.0985 1.61282 -58.9885 -21.8283 -5890 4 31.0506 36.3975 9.1055 -4.33965 11.8991 35.1417 -5891 4 31.0192 35.5887 10.4601 -6.41155 39.3119 -7.26857 -5892 6 45.5784 6.55949 25.24 49.1938 -13.828 -6.30557 -5893 4 44.6777 6.5515 25.5065 -25.461 -8.09624 7.65514 -5894 4 45.978 5.64009 25.2752 -26.9592 28.1751 -0.0529727 -5895 6 9.53089 30.0259 12.0468 18.203 -29.4993 -35.3826 -5896 4 9.87965 30.5113 11.2809 1.8895 2.86193 6.03312 -5897 4 9.26134 30.6784 12.652 -18.7794 25.6859 27.1844 -5898 6 53.0787 24.9761 1.37462 5.70131 11.5656 52.3682 -5899 4 52.7701 24.171 1.02302 -14.9871 -27.078 -25.8882 -5900 4 53.2426 25.5756 0.676612 4.18045 17.0305 -26.7636 -5901 6 26.1794 24.7359 0.502901 22.1176 -25.6344 -30.1555 -5902 4 25.7034 24.7594 41.5454 1.42755 5.35042 26.0986 -5903 4 25.8798 25.3805 1.12222 -18.0425 21.9232 11.274 -5904 6 23.006 2.41877 11.549 3.03835 0.786733 -23.201 -5905 4 22.1232 2.19651 11.8728 1.75899 -1.65202 1.96434 -5906 4 22.9163 2.42328 10.5701 -3.31062 2.24291 13.1011 -5907 6 29.9286 12.8953 30.9894 2.56623 -0.427284 6.89615 -5908 4 30.7531 12.7948 31.5295 -11.6926 9.48208 -25.7239 -5909 4 30.1452 13.1242 30.0532 3.97045 -7.90132 21.6369 -5910 6 24.0654 16.1863 40.3478 -8.57837 -16.1993 -7.0618 -5911 4 23.8181 16.8167 40.9886 -17.7345 17.1107 43.7161 -5912 4 24.4461 16.799 39.7307 8.03288 -6.21636 -19.956 -5913 6 21.8775 29.9129 12.7438 8.38993 20.3936 0.69825 -5914 4 21.1101 29.6022 12.2761 -16.411 -9.00989 -4.05561 -5915 4 21.7959 30.8814 12.6689 6.66677 -10.3308 5.74649 -5916 6 45.2196 12.276 6.62528 -23.2047 44.1078 30.1736 -5917 4 45.4494 11.529 6.11864 16.0879 -27.9404 -20.133 -5918 4 45.9267 12.944 6.63915 -2.18395 -9.27911 -10.7446 -5919 6 7.59043 25.3914 38.0243 42.7544 -18.087 21.3587 -5920 4 8.2454 25.1294 37.3073 -28.6085 13.3538 22.5553 -5921 4 8.06078 25.1795 38.9036 -17.5445 13.8955 -36.9473 -5922 6 46.1702 7.81994 16.6869 -21.8749 40.0263 -11.2018 -5923 4 46.5308 7.86296 15.7811 2.96678 -6.7279 9.6444 -5924 4 46.6568 7.20863 17.2067 24.29 -27.7199 6.2944 -5925 6 54.9712 12.8519 7.72645 -5.0392 -7.84126 -11.592 -5926 4 54.9715 13.8156 7.65436 -3.45199 -1.13943 9.08655 -5927 4 54.3111 12.5688 8.37934 8.51313 12.0297 -0.864167 -5928 6 26.936 39.6495 37.1759 1.87165 14.912 18.6021 -5929 4 27.6928 39.6002 36.5592 -3.34619 -10.0228 14.3716 -5930 4 27.1866 39.3914 38.108 -0.832196 -0.678219 -33.4669 -5931 6 27.0349 8.92218 38.0169 24.6524 -2.61622 -28.7715 -5932 4 26.316 9.52058 38.1337 -23.9094 17.4181 8.51603 -5933 4 27.4852 9.31616 37.2255 -4.7843 -14.0734 18.554 -5934 6 8.05135 7.65161 29.9116 12.1299 -7.94147 21.2544 -5935 4 8.62851 7.92802 30.6495 -6.35395 -5.29094 -12.0163 -5936 4 7.74814 8.47335 29.5547 -5.2558 18.4649 -14.2469 -5937 6 27.8737 27.8565 12.1051 -38.6038 15.3188 22.9885 -5938 4 27.4445 28.7122 12.3849 14.7215 -19.9621 -4.23437 -5939 4 28.6312 28.0341 11.5799 28.6137 10.9177 -18.1106 -5940 6 23.5548 30.5037 38.1558 -29.4871 -31.9475 26.5081 -5941 4 24.0962 30.758 38.9126 3.93335 7.76671 -5.43794 -5942 4 23.9417 30.8351 37.3772 21.2145 16.4773 -23.4003 -5943 6 48.0793 24.306 17.3344 -19.3615 12.8085 -14.3801 -5944 4 47.2872 24.7421 17.7455 27.359 -7.68532 -3.4425 -5945 4 48.1537 24.7387 16.4546 -0.580236 -6.90317 13.1114 -5946 6 38.498 5.30294 40.3305 40.7021 23.5094 2.62433 -5947 4 38.9475 4.64687 39.7972 -10.9193 -18.4764 2.07144 -5948 4 39.1882 6.01706 40.3225 -28.8653 -3.92995 8.38836 -5949 6 31.2337 3.92695 33.7301 -2.6422 16.6026 -6.87478 -5950 4 31.7948 4.28658 33.0166 -2.97898 -8.44373 7.32517 -5951 4 31.5298 3.03423 33.9266 10.3473 -9.06319 -0.444766 -5952 6 41.2426 8.81864 38.1104 -4.47266 -7.82466 24.3448 -5953 4 41.0373 8.41451 38.9755 -2.01902 1.52645 -10.1427 -5954 4 41.1368 9.75783 38.3095 7.23604 3.04516 -5.74389 -5955 6 53.3619 29.0937 24.5785 -40.2757 11.297 7.14485 -5956 4 52.5565 28.5537 24.7901 26.871 10.2044 -0.818821 -5957 4 52.9453 29.9599 24.3491 20.4755 -15.9472 -3.03 -5958 6 54.9044 15.544 40.7081 25.545 -57.3548 17.1629 -5959 4 54.9892 16.405 40.3633 -12.4948 43.2864 -12.4113 -5960 4 54.018 15.2891 40.9908 -7.57666 14.2468 -5.0348 -5961 6 46.3994 17.0672 31.8767 -6.245 16.1286 -17.5712 -5962 4 46.5114 17.9797 31.5283 3.34232 -11.2714 9.55259 -5963 4 45.8128 16.6602 31.1996 2.74349 5.02824 21.6551 -5964 6 36.898 25.0477 23.0493 11.3229 21.4084 -39.4528 -5965 4 37.2029 24.9737 23.9235 7.13326 -1.42781 43.2733 -5966 4 36.3025 24.3424 22.8486 -15.8402 -9.5757 6.36085 -5967 6 11.3692 4.41343 15.9249 15.7896 22.4119 -17.7964 -5968 4 11.3725 3.62473 15.3598 -3.28732 1.6252 14.2587 -5969 4 11.7055 5.11941 15.3214 -6.01385 -9.48847 12.8461 -5970 6 12.7845 7.07125 19.464 -10.6801 6.56169 22.7508 -5971 4 12.8604 6.27981 18.9655 14.1597 -21.8558 -24.6024 -5972 4 12.2771 6.71627 20.2197 6.8185 19.6013 -8.61559 -5973 6 12.0681 33.6471 17.5522 -1.52085 -17.496 -42.1785 -5974 4 11.9445 34.1189 18.3508 -6.25092 12.897 34.2466 -5975 4 12.5251 32.8183 17.7704 2.9394 6.95993 4.68875 -5976 6 10.2419 4.74292 2.55933 22.7613 10.361 1.71337 -5977 4 9.42389 4.50476 2.9876 -9.73314 -9.75152 7.74431 -5978 4 10.9687 4.12007 2.82053 -14.8261 2.90481 -11.2179 -5979 6 4.58785 36.8771 12.1606 -7.79451 -50.5455 -28.0593 -5980 4 4.4315 37.6675 12.6216 -0.588552 45.9766 17.7929 -5981 4 5.40236 36.9214 11.6472 0.781205 5.58305 7.99313 -5982 6 30.7591 35.3322 25.8391 -38.6972 -6.70904 -25.8809 -5983 4 31.308 35.3014 26.6139 2.09136 -3.6723 11.5509 -5984 4 29.8922 34.8696 26.0006 25.0535 4.09477 3.57125 -5985 6 20.1826 7.15897 1.87495 42.3449 13.1453 -15.8992 -5986 4 20.9155 6.54161 2.14653 -26.0098 16.5163 -6.36728 -5987 4 20.7109 7.92751 1.4772 -24.8109 -25.5601 12.7141 -5988 6 21.7554 6.89613 28.9929 -8.55274 -2.37394 -9.1913 -5989 4 22.0764 7.2366 29.8207 3.60587 3.07422 19.5812 -5990 4 22.5251 6.52709 28.5653 7.82832 -0.878326 -6.51175 -5991 6 6.87782 37.1389 6.94163 -1.13334 10.8563 13.3375 -5992 4 7.36847 37.9928 6.7949 -15.2779 -15.8129 7.53623 -5993 4 6.56156 37.0941 7.87645 12.8328 8.43507 -22.3513 -5994 6 37.1951 18.3599 16.3051 31.8484 54.3956 -63.0636 -5995 4 36.5686 18.6502 16.9278 -28.3708 4.63663 38.6073 -5996 4 37.3394 19.2548 15.8115 -3.93301 -42.965 18.1753 -5997 6 52.3874 25.498 31.3134 14.111 8.09505 3.74503 -5998 4 52.2596 26.4307 31.6656 16.8187 -33.1452 -9.3176 -5999 4 53.3531 25.244 31.2999 -24.6813 13.8962 6.4969 -6000 6 3.93514 39.8328 16.38 27.5969 -10.0907 -6.6773 -6001 4 3.11618 39.8354 16.8714 -5.56329 -11.6849 3.14974 -6002 4 4.25813 38.8985 16.2148 -16.7217 35.1377 3.93655 -6003 6 26.055 14.6352 18.3097 2.48745 23.0231 -5.4837 -6004 4 27.0121 14.5315 18.422 -4.58232 5.3017 0.111087 -6005 4 25.8831 15.6122 18.2324 0.591934 -25.1482 1.36918 -6006 6 22.1861 39.625 23.6336 -13.0035 -7.16992 22.0669 -6007 4 22.5756 40.4198 23.3178 20.0241 20.7615 -16.9022 -6008 4 21.775 39.9577 24.4575 2.36146 -17.5943 -7.81238 -6009 6 5.9827 12.8747 22.3739 5.28791 3.19174 -0.347139 -6010 4 6.16079 13.1981 21.4813 -0.557605 -0.80783 -0.954564 -6011 4 6.85402 12.6686 22.7296 5.64669 -4.60509 -1.11135 -6012 6 48.9358 28.1656 34.7093 -34.12 -15.1013 -7.57113 -6013 4 48.3009 27.4712 34.4428 -1.24475 21.7165 7.07681 -6014 4 49.7483 27.6911 34.6564 33.1581 1.27133 3.59264 -6015 6 7.76665 22.4378 33.2356 5.82113 4.36953 2.134 -6016 4 7.99414 22.0593 34.0982 -2.05459 -3.4103 -7.93698 -6017 4 7.15982 21.8587 32.7652 -2.05153 -2.03416 7.79212 -6018 6 41.0903 39.5994 11.7192 28.8485 25.6095 5.96672 -6019 4 40.6961 40.3697 11.3388 -29.9964 5.48828 -17.7316 -6020 4 41.854 40.0697 12.1081 -2.33823 -21.5528 5.66509 -6021 6 26.8801 37.922 39.3457 -9.67122 -13.15 30.7983 -6022 4 27.1418 37.9976 40.2903 -3.7646 7.48977 -14.0985 -6023 4 25.9915 37.5069 39.4007 11.6973 7.1772 -10.1587 -6024 6 16.8317 41.5399 16.7862 15.0313 6.40425 17.7164 -6025 4 17.5506 0.178386 16.4567 -5.24562 -1.69226 -13.3924 -6026 4 17.0965 41.4441 17.7156 -14.9292 -9.12078 -7.2801 -6027 6 19.02 8.9948 17.6728 1.01249 -20.0254 27.6053 -6028 4 18.8256 9.92734 17.8397 -2.50665 -0.780218 3.94781 -6029 4 19.0722 8.45531 18.5284 1.63313 22.2167 -34.6872 -6030 6 31.0993 24.379 20.1031 -5.45136 7.30173 -0.0135243 -6031 4 30.58 24.6604 20.88 7.69136 -4.59203 -13.2888 -6032 4 31.7465 25.0718 19.9526 0.652083 2.88804 -0.364555 -6033 6 24.6121 6.3117 27.596 -14.2942 3.47042 8.51555 -6034 4 24.6855 6.72112 26.7154 0.000835906 -11.6728 3.52597 -6035 4 24.4562 5.35726 27.5796 2.29956 0.742888 -9.80031 -6036 6 11.6309 5.33579 8.21245 48.3472 17.5789 -13.0214 -6037 4 10.7447 5.097 8.35577 -43.9811 -8.24091 9.59422 -6038 4 11.6324 6.14291 7.66014 -5.62825 -15.0071 6.92232 -6039 6 16.4828 34.2339 17.2467 58.9453 43.3211 -11.1422 -6040 4 15.833 34.737 16.7643 -22.9367 -4.06405 -2.05249 -6041 4 17.323 34.8225 17.0684 -41.083 -49.3458 15.3182 -6042 6 40.7431 40.4645 8.52128 12.2314 -11.8005 -21.5431 -6043 4 40.0246 40.6751 9.09883 -14.9736 5.2464 12.3608 -6044 4 40.4244 39.6664 8.05294 5.87539 10.603 6.78918 -6045 6 42.7463 5.87875 14.2877 12.74 -3.29305 -3.26541 -6046 4 42.0588 5.87807 14.9272 -15.1719 8.11415 20.4154 -6047 4 42.5132 5.11812 13.7588 -0.0411089 -3.23222 -11.0769 -6048 6 14.3659 21.065 6.06718 -46.5802 14.1632 25.7131 -6049 4 14.5381 21.6726 6.80844 -4.55135 -9.99097 -5.53618 -6050 4 15.2049 20.8313 5.76105 45.2018 -10.2131 -22.6687 -6051 6 16.2987 37.772 18.1217 -43.41 26.7654 24.2454 -6052 4 15.4242 38.2299 18.3727 36.2216 -25.3097 -28.3843 -6053 4 16.6845 37.7048 19.001 13.5629 -5.49997 -6.41318 -6054 6 40.7915 27.7152 27.1158 9.45156 2.81801 -4.91689 -6055 4 41.5456 27.319 27.566 -3.53201 -5.16081 10.0516 -6056 4 41.2155 28.2976 26.4751 -4.07016 3.79859 -1.40954 -6057 6 44.9595 25.9846 14.0499 3.3218 -15.4841 -8.79479 -6058 4 45.329 25.1566 13.6433 -5.22711 26.2877 13.1546 -6059 4 45.4837 26.7406 13.7529 4.37393 -9.76715 -6.45081 -6060 6 2.62066 33.9505 21.2427 -16.9582 -3.86849 -3.69815 -6061 4 2.06211 34.7496 21.3041 9.37305 -3.74186 4.79914 -6062 4 2.1388 33.3568 20.6382 5.47892 10.3925 4.65279 -6063 6 5.77806 4.43691 12.8378 4.70319 28.9306 -8.8144 -6064 4 5.36233 3.72198 13.3221 -5.81749 -8.58488 4.20714 -6065 4 5.80863 5.24637 13.3804 -1.3041 -13.5761 2.8333 -6066 6 16.8665 5.92021 7.40582 23.56 -3.08178 3.03829 -6067 4 16.4354 5.08697 7.20958 -2.89912 -12.7512 -7.28137 -6068 4 16.1638 6.54304 7.4701 -21.737 13.5702 4.65232 -6069 6 17.8259 38.4084 36.8446 -8.45971 28.6621 19.1884 -6070 4 17.7005 39.3712 37.0468 11.155 -18.7052 -15.1769 -6071 4 18.5325 38.3077 36.2071 4.43545 2.51623 -4.89916 -6072 6 43.3084 20.5973 5.4325 -39.7754 20.35 -2.23031 -6073 4 43.0204 21.5105 5.15286 19.9417 -23.843 3.70329 -6074 4 42.4274 20.1471 5.43024 22.0601 -2.53082 1.71294 -6075 6 21.5318 23.3 30.4444 10.3709 20.0389 -42.3415 -6076 4 21.0369 22.9394 31.1576 -20.9289 -4.03021 22.2109 -6077 4 20.911 23.6578 29.7428 10.7798 -15.246 22.7192 -6078 6 0.249866 28.0345 36.1724 -10.1983 37.6035 -27.6546 -6079 4 1.05324 27.7572 36.576 20.3102 -14.8665 16.9966 -6080 4 0.540234 28.832 35.6712 -10.982 -12.5736 6.41543 -6081 6 3.04754 17.0516 11.5683 -6.97145 7.64509 -15.3824 -6082 4 3.16434 17.3061 12.4746 3.36597 -0.550097 20.9912 -6083 4 2.52404 17.7798 11.2137 2.91457 -3.72579 -4.7217 -6084 6 24.1788 37.0366 23.9551 -12.9856 4.64226 12.2764 -6085 4 23.6099 37.826 23.831 6.85326 -8.75197 5.00341 -6086 4 24.4012 36.9865 24.9175 -1.53567 3.17074 -21.6248 -6087 6 3.95494 20.5134 27.4915 2.8093 53.7214 17.1103 -6088 4 3.58105 20.0931 26.7551 -14.7022 -26.8908 -38.8522 -6089 4 3.8118 21.4686 27.2477 5.25372 -20.6261 11.8203 -6090 6 54.8404 2.77723 29.6182 19.2518 19.5174 31.7291 -6091 4 54.8688 2.43537 30.559 -2.71579 12.5717 -24.6672 -6092 4 0.596183 3.44189 29.5911 -17.1059 -25.2514 0.407437 -6093 6 27.1931 8.41834 31.7378 -5.45838 77.4793 -29.1542 -6094 4 26.7872 8.25949 30.8671 -2.01983 -12.8877 1.93898 -6095 4 27.4107 9.43311 31.6496 -7.24897 -56.0438 21.5563 -6096 6 30.967 1.65521 30.3853 -24.4372 0.252197 19.6085 -6097 4 30.699 0.824835 30.0215 -2.04196 -23.8902 -26.6583 -6098 4 30.1085 1.94064 30.7387 6.28416 6.26069 6.0985 -6099 6 26.4053 36.4472 36.8445 23.7132 4.61357 6.55265 -6100 4 26.2095 35.8808 36.1068 -5.45287 -5.64468 -12.8873 -6101 4 27.3732 36.593 36.8324 -14.4493 2.44748 -3.93886 -6102 6 51.2993 10.0458 21.7014 24.6671 -30.2423 2.93053 -6103 4 50.7417 9.318 22.0589 9.26734 22.884 -6.07289 -6104 4 52.1551 9.59094 21.4448 -31.6711 18.7199 5.84467 -6105 6 52.4308 12.3792 23.2584 -6.42579 27.1004 22.8118 -6106 4 51.6946 13.0394 23.3088 16.6887 -7.91574 -6.77392 -6107 4 52.0327 11.5757 22.9611 -11.4365 -20.1199 -14.9439 -6108 6 9.99751 38.3699 20.6117 28.0449 -1.18219 -11.795 -6109 4 9.42862 38.2366 21.3654 -6.81781 0.619005 12.6857 -6110 4 10.9196 38.1916 20.8926 -11.789 -1.89114 -3.31064 -6111 6 22.7111 33.2651 0.632604 -8.26324 25.0772 17.5737 -6112 4 23.6702 33.3984 0.628432 0.752102 -10.2993 -4.51528 -6113 4 22.4939 32.4115 0.275412 2.14165 -18.6843 -11.1325 -6114 6 14.0859 40.8716 25.4956 -8.46488 1.55142 -11.4693 -6115 4 14.0599 40.7138 26.4427 12.1567 0.227551 5.06398 -6116 4 13.2623 40.45 25.1949 6.8133 8.32038 -2.55804 -6117 6 42.7734 15.0947 14.9538 14.4784 5.50426 -3.8277 -6118 4 43.0583 15.7694 14.2817 -8.42225 -24.0175 22.033 -6119 4 41.8405 15.2241 15.1238 -9.70916 3.613 0.791575 -6120 6 30.2327 7.231 8.54228 -3.22532 10.2874 -46.9304 -6121 4 30.2058 8.2102 8.45082 -0.363858 -13.9116 11.7844 -6122 4 30.4404 6.92219 9.39771 6.32383 2.81905 38.5597 -6123 6 3.37293 19.847 41.3038 28.0406 -0.792001 0.268463 -6124 4 3.19157 19.2836 40.5407 -0.0866071 4.98821 -2.30354 -6125 4 4.34764 20.0104 41.227 -24.6382 -4.50526 4.46777 -6126 6 8.87233 25.1482 17.2024 12.9182 -25.3276 -29.7935 -6127 4 8.99656 24.7585 16.2934 -10.9438 23.5455 20.5923 -6128 4 9.70028 24.8859 17.6216 -4.47076 0.166054 9.91948 -6129 6 9.34357 14.9539 22.0324 -26.1912 3.45279 3.87325 -6130 4 9.00509 14.8035 22.9321 4.97494 4.93375 -7.4516 -6131 4 10.1685 14.4775 21.9786 8.71262 0.391972 2.49596 -6132 6 2.03472 4.77693 20.8549 -5.0231 -16.4156 -4.2241 -6133 4 2.70086 5.4497 20.9192 18.9425 7.91266 2.94425 -6134 4 1.28907 5.15394 21.3146 -15.2358 3.90158 4.43282 -6135 6 18.286 7.04631 3.85489 -3.97091 0.415968 51.7005 -6136 4 18.7541 7.10917 3.04736 31.918 9.65669 -29.8899 -6137 4 18.8529 6.48913 4.44789 -12.6499 14.6692 -9.5202 -6138 6 17.0004 19.1661 19.8445 11.8294 -6.56912 -12.2376 -6139 4 17.7808 18.891 19.3473 0.445698 5.6808 3.33406 -6140 4 16.3387 18.5282 19.5337 -1.78106 12.0244 12.6463 -6141 6 4.30992 6.55322 21.357 27.1319 -4.11604 -15.0588 -6142 4 4.37542 6.91771 20.4543 -7.8574 5.76294 11.3657 -6143 4 5.24976 6.29093 21.5457 -28.1422 4.34799 0.417434 -6144 6 20.7778 36.9247 35.6618 12.7574 4.02765 2.49936 -6145 4 20.2864 37.0887 34.8562 -7.2468 0.0429553 -2.15645 -6146 4 20.2346 36.372 36.2389 -2.87094 1.27188 3.61263 -6147 6 4.73067 15.0203 31.2359 -10.2649 -12.7571 22.9725 -6148 4 4.37694 14.8342 32.1428 11.1861 -2.73027 -21.4712 -6149 4 4.72677 15.9733 31.1768 1.84417 11.2425 -7.2724 -6150 6 2.35535 1.23403 17.5726 17.2813 12.9738 -21.7174 -6151 4 3.03402 1.36527 16.8495 -17.2186 -13.1695 22.3246 -6152 4 1.92973 2.10387 17.6452 0.590267 -7.80147 9.6411 -6153 6 34.6252 31.5686 19.7984 -1.60729 -4.66139 0.568696 -6154 4 34.8929 31.9422 18.9439 4.49305 -5.18782 4.12596 -6155 4 34.4714 32.3271 20.3758 -2.9002 2.23803 -3.07041 -6156 6 24.1913 21.6089 13.5036 44.4004 0.328862 15.9674 -6157 4 25.0757 21.8297 13.9142 -30.8821 -6.11275 -18.7564 -6158 4 23.5519 22.0563 14.035 -11.4749 15.2668 7.23318 -6159 6 37.218 41.0972 5.69166 19.5034 -37.5651 -15.7416 -6160 4 37.88 41.7374 5.923 7.59407 13.6828 5.23653 -6161 4 36.3807 41.3769 5.99879 -24.6171 21.3167 5.70938 -6162 6 8.42841 7.99247 20.2345 27.9918 -33.0924 -23.0682 -6163 4 9.34968 8.06233 20.5347 -4.8675 5.92304 8.61954 -6164 4 7.93058 8.66586 20.633 -20.9635 39.4709 23.1164 -6165 6 14.934 18.8758 36.75 17.7625 18.3313 11.0559 -6166 4 14.0949 19.1945 36.41 0.856939 4.31409 -3.77921 -6167 4 15.6034 19.6084 36.7133 -18.5855 -12.9909 -4.44137 -6168 6 43.9791 40.6449 18.6524 7.41508 -0.428335 24.9958 -6169 4 43.9624 40.7544 17.7052 -3.16787 6.2189 -16.8328 -6170 4 44.8981 40.8188 18.9384 -9.62798 -9.77666 -5.30663 -6171 6 33.7986 32.259 37.3472 -15.5926 9.65631 -28.1821 -6172 4 34.0274 32.2295 36.4014 -5.19534 3.83485 15.8105 -6173 4 34.1945 31.4931 37.7276 18.2887 -12.3889 13.4194 -6174 6 5.09973 29.2834 24.0252 13.8314 -2.01249 29.2407 -6175 4 5.66693 29.5091 24.8044 -5.06459 -6.54793 -18.8628 -6176 4 4.76417 30.1245 23.7257 -5.49348 12.2693 -6.11875 -6177 6 33.6015 36.4179 10.971 30.294 2.53226 6.78363 -6178 4 32.7735 36.2836 10.5343 -15.5054 6.45725 -2.01925 -6179 4 33.4383 36.5424 11.9099 -7.56878 -2.98124 3.33663 -6180 6 28.3001 33.6166 13.1114 -3.16981 -41.1231 7.22112 -6181 4 27.986 33.7275 12.219 -4.10441 9.98298 -8.29397 -6182 4 28.0891 32.6746 13.2632 10.0083 14.4728 2.55385 -6183 6 6.1623 19.0624 24.2873 5.31394 -11.2621 -36.8053 -6184 4 5.95503 19.8074 24.8143 -4.51254 28.8134 22.7686 -6185 4 6.28788 18.3114 24.8476 4.1007 -18.6743 20.2695 -6186 6 28.4211 19.9362 1.86305 -4.43245 7.71948 8.08869 -6187 4 28.5604 19.4518 1.05094 6.94613 -11.0067 -8.65768 -6188 4 29.2593 20.0693 2.30859 5.46778 1.78077 -4.74455 -6189 6 42.0505 23.9714 9.55892 6.22877 26.0941 -5.00732 -6190 4 42.391 23.8165 10.4395 -2.03908 -8.00084 11.8727 -6191 4 41.7886 23.1541 9.15249 -7.7641 -22.6922 2.79783 -6192 6 43.5253 7.315 27.4414 4.48568 -18.9578 -0.168547 -6193 4 42.7359 7.07504 27.9388 -6.2009 1.74131 6.88183 -6194 4 43.2052 7.88335 26.7439 -2.31843 16.2411 -9.46916 -6195 6 20.4956 32.9945 9.25625 -63.2008 -2.41398 62.3431 -6196 4 19.7614 32.7323 9.96384 46.0698 -1.29529 -42.5223 -6197 4 20.3338 33.9485 9.24422 8.88758 3.29294 -12.4302 -6198 6 38.0318 35.2729 15.9427 -5.10059 -23.3836 -5.94715 -6199 4 37.3995 34.9842 15.2568 2.89047 3.01243 8.00796 -6200 4 37.9835 34.6007 16.6396 -2.13864 4.37071 -5.14357 -6201 6 47.5248 20.8808 3.95546 13.1177 31.1209 27.8573 -6202 4 48.0834 21.3954 3.36869 -6.69878 -8.89675 -13.1919 -6203 4 47.6052 21.4353 4.7772 -13.2785 -23.1226 -13.8569 -6204 6 10.9875 31.6892 41.4239 15.5099 5.40423 7.74084 -6205 4 11.658 31.8708 40.7529 -4.12469 -5.30401 -0.84079 -6206 4 10.1343 31.6927 40.9879 -7.96504 0.77506 -5.12071 -6207 6 43.245 12.6563 2.56138 15.9633 -17.8577 -2.60545 -6208 4 42.9226 12.9752 3.38765 -12.1061 12.2594 19.7928 -6209 4 43.9805 12.0851 2.8659 -6.2276 8.95994 -12.8364 -6210 6 49.4104 25.4124 21.1593 7.68799 -7.2912 5.83542 -6211 4 50.1422 25.2884 20.5387 -8.96396 0.548785 -4.3756 -6212 4 48.9554 24.5515 21.2297 -0.219253 8.20777 -2.75058 -6213 6 1.96484 34.1377 26.4635 6.42117 -7.58108 12.8955 -6214 4 2.78995 33.6488 26.6876 -20.6965 7.00883 -11.752 -6215 4 1.22498 33.5087 26.4121 8.61724 -1.18295 0.134997 -6216 6 17.1337 20.8362 36.6743 -37.6695 15.6036 21.8376 -6217 4 16.9634 21.7284 37.0778 2.65776 -21.0237 -14.9647 -6218 4 18.0617 20.7108 36.604 32.6572 -5.60583 -3.13187 -6219 6 36.5992 10.9735 3.70439 10.6975 8.82737 -5.2901 -6220 4 35.7369 11.4094 3.76988 -2.71865 -0.136466 14.5734 -6221 4 36.9547 10.7712 4.57736 -11.0261 -1.49358 9.11508 -6222 6 14.2213 20.6732 21.973 14.9521 39.3927 -42.8738 -6223 4 13.9206 20.2439 21.1689 -11.1282 -8.72354 1.45028 -6224 4 14.6851 21.4628 21.5779 -7.13343 -24.0966 22.8635 -6225 6 33.9052 12.2539 9.56536 64.6676 -19.1083 -72.943 -6226 4 34.3898 11.482 9.88615 -11.1791 5.59008 13.1859 -6227 4 33.2619 12.5422 10.1406 -48.1209 12.4396 55.8498 -6228 6 21.8075 41.4938 2.15247 -4.53434 0.170379 -15.7872 -6229 4 22.04 41.6038 1.2069 -3.47083 0.972349 16.0219 -6230 4 22.4007 40.8419 2.51679 12.4955 -1.6466 3.58022 -6231 6 20.9241 10.4413 14.2084 23.7182 11.537 17.3335 -6232 4 21.6155 10.8692 14.7979 -25.0251 -17.572 -17.464 -6233 4 20.772 9.54041 14.5736 6.4121 16.6732 -7.22543 -6234 6 6.25992 4.45494 24.6446 -20.993 10.5392 9.58783 -6235 4 6.70633 4.20365 23.8452 17.869 -10.7134 -15.0213 -6236 4 5.71116 3.71075 24.9084 -2.77077 -5.20552 -8.90983 -6237 6 50.776 14.5967 23.4784 31.7068 8.96229 10.5861 -6238 4 51.3012 15.0259 24.1918 -10.5702 -1.89466 -14.6802 -6239 4 49.902 14.4731 23.8252 -15.4415 -8.6063 7.51113 -6240 6 52.7906 13.9066 9.67243 -4.11462 48.2741 -4.64476 -6241 4 52.8606 13.0389 9.99278 3.823 -46.6932 12.5875 -6242 4 51.8698 14.0585 9.47707 -15.983 -0.946523 -10.048 -6243 6 9.04475 2.0467 29.9184 -38.5307 -30.621 -19.1189 -6244 4 9.46565 2.82007 30.2002 17.3321 39.2201 17.0183 -6245 4 8.08016 2.26538 29.8177 25.0495 -3.86709 2.38687 -6246 6 7.14389 29.9898 26.2407 4.70582 -42.771 12.4286 -6247 4 6.53112 30.404 26.8495 -5.08686 4.52864 3.1398 -6248 4 7.41427 29.1442 26.7142 -2.42767 26.6911 -17.7681 -6249 6 49.1638 41.7413 14.3375 -4.64089 27.4779 2.19815 -6250 4 49.5241 41.3828 13.5134 1.94418 -6.50091 1.47491 -6251 4 49.3811 0.802946 14.3236 2.14399 -30.2019 -5.07663 -6252 6 5.64888 3.82667 19.1906 -2.72189 -11.1411 26.1263 -6253 4 5.18678 3.36179 19.9258 5.23606 10.5823 -14.7259 -6254 4 5.05621 3.82399 18.4509 -7.60985 1.79477 -11.7277 -6255 6 9.32681 35.8274 24.8975 3.55565 13.5922 8.51546 -6256 4 10.2018 35.8152 24.4762 -3.06017 -4.39849 2.56743 -6257 4 9.46171 36.417 25.6586 -3.66837 1.49938 -3.23358 -6258 6 53.0285 29.7558 11.5499 -7.83487 -2.48558 9.64451 -6259 4 53.3653 30.4407 10.9686 7.5475 4.44921 -4.95089 -6260 4 52.7971 30.2083 12.3783 3.5824 -3.07517 -4.75195 -6261 6 22.6104 9.96627 5.67467 11.8622 1.90434 48.3765 -6262 4 23.3836 10.3266 6.15809 -8.36646 -10.9093 -7.81297 -6263 4 22.6398 10.3769 4.83333 -6.21393 7.91547 -32.804 -6264 6 39.5293 19.6134 2.67969 28.3515 9.20962 14.5311 -6265 4 38.5781 19.5068 2.58618 5.24604 -11.8744 -9.9137 -6266 4 40.0367 19.3939 1.87869 -17.6459 -1.04308 -3.70363 -6267 6 45.0742 35.5802 7.80399 12.9966 -1.00157 -13.6899 -6268 4 45.1073 36.2582 8.46111 4.45786 22.5875 10.9896 -6269 4 44.5296 34.9182 8.21469 -15.7495 -15.8794 0.100297 -6270 6 29.7829 14.2459 9.96531 -11.2509 -10.5838 -6.95263 -6271 4 30.0063 14.1556 9.0247 4.7074 -2.26926 1.20969 -6272 4 28.8478 13.9409 10.004 20.3358 11.6689 4.42407 -6273 6 29.2532 30.1489 21.8872 -22.7358 8.41186 19.7293 -6274 4 29.1261 30.8351 21.2312 3.02893 4.58934 -9.48892 -6275 4 30.0577 29.6729 21.7506 17.9631 -9.68935 -13.2514 -6276 6 11.1028 18.8149 6.56446 12.6172 11.1172 -5.75863 -6277 4 11.2898 19.7306 6.3073 -12.9819 2.38317 -1.53669 -6278 4 11.9922 18.4416 6.57196 0.724871 -8.7617 2.86424 -6279 6 13.403 39.1446 13.4748 19.5871 -11.9429 -30.0571 -6280 4 13.7697 39.8507 13.9939 7.8117 10.5151 13.4831 -6281 4 12.6292 38.8582 13.9386 -20.2152 -7.12839 8.32373 -6282 6 50.1432 12.9893 0.138872 33.4511 24.3017 64.4039 -6283 4 49.8497 12.6921 41.2405 -20.6967 -26.8999 -59.7452 -6284 4 50.7523 12.3231 0.503203 -9.52656 2.062 -3.94446 -6285 6 47.8312 31.3446 27.7846 -28.8076 12.8422 -13.2841 -6286 4 47.8833 31.94 28.5222 10.4006 4.03183 17.8143 -6287 4 46.9755 31.6479 27.4044 17.0933 -18.1054 -4.43643 -6288 6 27.7087 1.63781 7.50008 21.5285 -7.57238 -25.6841 -6289 4 26.9556 1.59549 8.05597 -25.0455 5.22958 17.9803 -6290 4 27.5166 0.963037 6.82134 -2.90509 7.89899 -0.0646572 -6291 6 54.8922 20.8 16.0331 4.1789 -41.4982 -7.93337 -6292 4 54.9282 20.9554 16.9716 0.186425 8.83729 15.9831 -6293 4 0.211633 19.8495 15.948 -9.91253 29.0383 -5.43741 -6294 6 37.4291 33.0056 34.4398 -14.0977 10.8622 -7.94924 -6295 4 37.2978 32.0826 34.6133 -1.58878 -21.6351 7.1631 -6296 4 36.5764 33.2755 34.0173 17.7258 4.45123 10.3439 -6297 6 19.5104 39.7742 6.7506 5.90241 -38.4201 -4.61078 -6298 4 19.1293 39.2182 6.01225 10.8403 19.9531 16.5545 -6299 4 19.9162 39.0938 7.35425 -12.9804 24.3225 -11.3083 -6300 6 32.4399 2.72699 8.06906 17.0773 23.4006 1.78158 -6301 4 32.9347 3.14941 8.81642 -19.9733 -16.2934 -9.37408 -6302 4 31.5531 2.49842 8.37658 0.516726 -6.41942 5.39598 -6303 6 12.9757 16.0915 4.06618 3.48233 -26.1302 -11.2272 -6304 4 12.5744 15.6527 4.83433 -0.695682 4.00385 -3.98901 -6305 4 13.3513 15.3473 3.55621 -4.30287 11.2057 5.6128 -6306 6 4.64677 29.9233 5.42983 -10.8182 14.2385 -56.8973 -6307 4 4.99957 30.1958 4.52107 -6.90737 -7.02982 36.161 -6308 4 3.86081 29.3683 5.18005 29.0195 11.7205 17.0104 -6309 6 29.7541 32.1122 24.0662 13.5325 13.0696 7.67536 -6310 4 30.657 32.2311 24.4313 -14.6232 -5.62961 -5.85099 -6311 4 29.8358 31.5529 23.3009 -2.99915 -14.1964 -7.88188 -6312 6 11.8689 30.6971 33.4711 -8.01032 -39.2081 28.7873 -6313 4 11.8961 29.8478 34.0479 -0.904256 41.1124 -29.4381 -6314 4 12.7288 30.7703 33.0546 6.62137 -3.78113 1.33903 -6315 6 17.3676 40.4123 27.3051 45.9752 30.8726 -27.1152 -6316 4 17.3095 41.3718 27.4557 -2.78012 -6.90788 -0.219066 -6317 4 16.6513 39.9873 27.6906 -54.0346 -15.2197 27.4879 -6318 6 8.66734 4.89901 8.93063 6.14116 -5.58058 -4.6479 -6319 4 8.35347 5.40804 8.18272 -1.2331 1.82325 -6.13974 -6320 4 8.16334 5.22925 9.67691 0.199365 1.34734 7.84993 -6321 6 39.5604 17.6833 9.57201 22.5105 -50.1639 -23.667 -6322 4 39.2658 17.6048 10.464 -10.5204 8.51393 23.2154 -6323 4 39.725 16.7168 9.31019 -10.6666 45.7312 -1.86495 -6324 6 31.4955 30.1755 28.5516 10.628 -19.507 17.1882 -6325 4 32.3525 30.3948 28.1778 -6.71462 8.32315 -8.11857 -6326 4 31.74 29.3729 29.0438 -14.9082 5.37925 -0.357203 -6327 6 52.6685 19.2672 40.0663 9.25056 16.4026 -20.0757 -6328 4 53.0106 18.7322 39.321 -9.61724 -4.6138 17.4516 -6329 4 53.0677 20.1385 39.8955 -5.74465 0.792691 -1.74468 -6330 6 3.24164 7.81666 9.85998 28.0429 9.66948 1.15728 -6331 4 3.83019 8.53432 10.2304 -23.9275 -17.8293 -12.7584 -6332 4 3.84853 7.29279 9.3074 -9.38214 5.4782 3.90821 -6333 6 23.129 35.218 35.5945 -25.4929 1.01472 15.9258 -6334 4 23.7784 35.3391 34.9359 33.2897 3.00284 -24.4901 -6335 4 22.5015 35.9398 35.4197 -4.85807 -5.03855 8.29984 -6336 6 19.51 14.0653 20.8221 -35.7596 -3.44758 -1.61502 -6337 4 19.8587 14.4985 21.6011 13.4146 6.44294 7.16022 -6338 4 18.5274 14.0852 20.9637 18.4505 -1.93413 -5.69736 -6339 6 23.6205 15.8624 24.0207 6.44012 -27.6666 -1.73497 -6340 4 23.7023 16.8084 24.0387 5.71305 22.1977 -2.17526 -6341 4 24.4604 15.4749 23.6823 -15.4387 15.2983 3.34328 -6342 6 0.280487 30.496 6.10097 2.10248 14.5258 38.6463 -6343 4 54.969 30.1752 5.28655 -5.78718 -18.1599 -43.8305 -6344 4 54.4568 30.8162 6.51538 2.11893 2.60892 6.09244 -6345 6 4.88818 13.213 29.1211 -10.1066 -44.834 -24.7823 -6346 4 4.81121 13.8494 29.7943 -5.77674 34.7781 35.8081 -6347 4 5.65875 13.4519 28.6173 14.302 5.76116 -10.624 -6348 6 54.2113 27.2762 19.1921 -15.5686 -30.3542 31.9917 -6349 4 0.068746 27.3681 19.6083 11.8738 0.793184 4.88761 -6350 4 54.2438 27.8077 18.4285 0.565084 22.1088 -37.313 -6351 6 13.9147 35.7477 9.19539 -9.45761 -42.0549 -30.4782 -6352 4 13.6498 35.0288 8.53341 12.0253 23.1831 27.3793 -6353 4 13.9217 36.5134 8.63033 3.91359 16.7787 -6.83247 -6354 6 5.91895 31.9062 18.8199 -10.5522 26.6577 -12.1166 -6355 4 5.59368 32.8276 18.7738 -3.70357 -9.82177 15.0022 -6356 4 6.3357 31.8271 17.9661 5.53766 -12.0386 -9.76018 -6357 6 5.80079 28.8629 9.48582 -4.23387 2.66619 -7.91216 -6358 4 5.1492 29.3316 10.0156 -4.194 3.81529 3.65919 -6359 4 5.26808 28.2356 8.96551 5.75879 5.11243 0.385299 -6360 6 40.1186 6.06288 9.7252 27.6823 -14.9678 -34.8134 -6361 4 40.0604 6.61837 8.91786 -4.97866 -6.72317 19.9534 -6362 4 40.8451 5.41953 9.46609 -26.5422 19.2978 14.9684 -6363 6 20.3249 13.4665 41.4109 48.5393 0.491453 -34.6424 -6364 4 21.248 13.7047 41.7262 -35.6043 -9.97545 -2.58991 -6365 4 20.4078 13.625 40.4256 -17.6073 -2.89865 23.6593 -6366 6 14.4355 21.7431 27.3521 26.8888 -5.93952 12.1752 -6367 4 15.3929 21.7238 27.5426 -15.4302 4.65814 3.66232 -6368 4 14.4086 21.5632 26.4128 -6.38145 3.02673 -3.91912 -6369 6 38.7552 1.80385 30.0529 11.0268 -28.3612 -27.359 -6370 4 38.4475 1.96331 30.9218 -11.1335 10.8767 32.3314 -6371 4 38.864 2.66369 29.6567 5.01485 14.1269 -3.82072 -6372 6 5.6038 10.8537 14.1812 -8.02182 -19.6512 10.0037 -6373 4 4.967 11.5707 14.1035 -3.71772 1.30399 -2.93081 -6374 4 5.11243 10.0991 14.6 11.6474 17.9462 -13.8385 -6375 6 45.4185 36.7135 27.9228 -18.8199 18.417 -42.2307 -6376 4 46.0687 36.7087 28.6222 8.21134 6.27257 3.16342 -6377 4 45.7172 37.2784 27.1471 -3.80026 -24.227 32.4306 -6378 6 54.0799 35.0377 20.3974 -0.144446 0.236923 -11.8112 -6379 4 53.8476 34.1116 20.536 0.519878 -4.41527 -2.37245 -6380 4 53.9532 35.2077 19.4441 0.866973 -0.817495 13.7238 -6381 6 42.0671 14.221 28.4749 -2.16655 -3.30611 3.54679 -6382 4 41.9442 13.9043 29.3971 9.00113 8.16851 -11.079 -6383 4 42.9986 14.4434 28.31 -2.56617 -4.72525 9.98454 -6384 6 34.845 7.68802 26.7053 1.50556 20.2543 7.34306 -6385 4 35.7046 7.39142 27.0344 -1.60005 -9.47728 3.59716 -6386 4 34.4934 7.05976 26.0702 4.4346 -10.8207 -3.70702 -6387 6 49.6605 30.7141 23.8514 -28.5275 -6.56067 -11.9374 -6388 4 50.4604 31.1934 23.8565 34.1351 17.5516 -0.640456 -6389 4 49.8146 29.9659 24.4072 5.37992 -19.8924 15.651 -6390 6 50.8948 7.80148 14.1671 21.5777 -12.9452 34.2787 -6391 4 50.8247 6.96775 13.7105 -4.99079 -12.0182 -18.7136 -6392 4 50.5655 8.51894 13.6572 -15.7049 17.9748 -24.3233 -6393 6 4.26893 39.4826 27.8512 8.9926 -8.51629 -1.47833 -6394 4 3.65831 40.2241 27.8513 -3.04259 7.34368 5.94949 -6395 4 4.00328 38.958 27.1013 -12.9816 -10.5728 -11.1653 -6396 6 8.75177 32.8341 8.22283 -21.5639 -30.1985 -34.1316 -6397 4 8.2383 32.1284 7.72694 10.6374 17.547 21.6449 -6398 4 8.83279 33.5372 7.56693 3.76401 9.53239 7.06969 -6399 6 52.9594 25.4882 9.38297 -25.0802 50.1357 20.0056 -6400 4 51.9882 25.4292 9.65119 35.7509 1.27265 -17.7678 -6401 4 53.158 26.4759 9.49827 -6.53976 -44.9947 -5.62964 -6402 6 29.5661 36.7256 19.4603 5.44621 -17.3757 32.4066 -6403 4 29.5786 37.3961 18.7906 9.88328 7.74732 -15.4263 -6404 4 30.4565 36.6309 19.8726 -14.3545 4.38723 -10.5986 -6405 6 52.3236 36.1013 25.1169 17.8415 -25.8683 -35.0149 -6406 4 52.9656 35.7372 25.71 20.0999 5.67458 7.00157 -6407 4 51.6595 36.4261 25.6714 -35.904 19.3861 23.0835 -6408 6 21.182 15.7103 31.1872 -18.8583 3.19523 -20.0756 -6409 4 20.6533 16.2005 30.5215 19.2403 -4.60119 13.454 -6410 4 20.518 15.2243 31.6931 2.46505 1.20146 2.10658 -6411 6 10.6569 22.4337 39.4531 2.51655 -26.4213 -37.4968 -6412 4 10.8327 22.4219 38.4645 -4.29248 9.16844 28.2769 -6413 4 10.2506 21.5589 39.6181 7.08653 12.2011 0.686531 -6414 6 25.1113 11.6729 22.7164 -12.9971 -0.576423 -18.0399 -6415 4 25.1382 11.4787 23.6279 21.2779 0.00518046 39.517 -6416 4 24.1824 11.5118 22.5586 2.84555 -0.272219 -17.8246 -6417 6 31.7896 10.4703 2.90217 -23.2712 -10.1944 -9.79051 -6418 4 32.6146 10.7499 3.28348 13.8778 6.97942 -8.99307 -6419 4 31.8394 10.4464 1.92418 10.0551 5.29594 18.2662 -6420 6 52.4849 36.4361 22.1663 -9.62786 -33.6069 5.21212 -6421 4 53.146 36.0606 21.5474 -12.5852 0.946736 4.3316 -6422 4 52.0694 35.6392 22.6209 17.7505 30.3514 -16.202 -6423 6 46.2093 40.0329 26.9877 0.0297183 29.9961 33.6049 -6424 4 46.4751 39.2742 26.5126 9.55695 -26.8643 -22.4205 -6425 4 45.9048 40.7092 26.3771 -3.76152 -2.91476 -3.34389 -6426 6 24.0885 36.7218 39.1011 7.12362 -3.16907 -4.80429 -6427 4 23.5999 35.9078 38.9667 11.8985 -11.6148 -5.9332 -6428 4 23.4559 37.2234 39.5891 -11.7402 16.6095 17.3029 -6429 6 22.3514 7.42547 31.8169 -35.2707 -41.8068 15.3628 -6430 4 22.2213 8.33277 32.0647 5.94025 21.3422 4.40196 -6431 4 21.6465 6.92073 32.3398 32.1745 21.6054 -24.7594 -6432 6 14.3502 18.3597 4.09728 -2.0055 -9.38358 23.348 -6433 4 14.1099 17.4219 3.93107 -0.92654 19.6042 10.3569 -6434 4 14.0726 18.5364 5.03654 13.0175 -10.3464 -23.9346 -6435 6 27.3175 38.46 0.124188 33.1007 -9.911 1.68747 -6436 4 26.9395 39.2806 0.463932 -4.88512 2.40457 5.81864 -6437 4 28.2608 38.413 0.45438 -35.2324 2.96259 -2.16122 -6438 6 18.6695 0.162292 12.2239 -43.166 1.81748 26.3235 -6439 4 17.7303 0.262878 12.5713 26.4571 2.30278 -22.2908 -6440 4 18.9433 41.3202 12.7499 8.63834 -11.46 6.42912 -6441 6 49.423 24.9792 25.3382 20.605 1.42964 -0.346179 -6442 4 48.5484 24.7002 25.6009 -12.613 -0.556076 -3.92373 -6443 4 49.3508 25.8032 24.8352 -9.8769 -5.62219 -3.2466 -6444 6 52.0685 20.2858 15.7446 -45.9435 -8.75518 14.7384 -6445 4 52.9731 20.5149 15.783 39.268 6.79994 2.42829 -6446 4 51.7449 20.2597 16.6676 4.81444 3.79951 -9.92674 -6447 6 49.6576 15.6472 38.4942 19.425 -17.6129 -0.00729052 -6448 4 49.2099 16.0165 37.7231 -6.98596 1.36616 -1.50856 -6449 4 49.5102 16.1958 39.2633 -14.7214 13.7889 5.58845 -6450 6 15.9211 23.7235 13.4193 23.3289 -36.8815 11.3263 -6451 4 16.506 23.7025 14.2147 -19.633 8.70021 -19.3267 -6452 4 15.5217 24.5725 13.2813 -7.62789 19.6624 11.7876 -6453 6 14.3566 29.1635 14.3074 -12.0826 22.9902 -11.8551 -6454 4 14.1263 29.6193 13.4563 6.10678 -19.1115 21.2229 -6455 4 14.1254 29.8374 14.9735 4.9154 -5.66101 -4.10969 -6456 6 30.4264 19.8612 16.8883 21.8822 -42.1222 -1.02119 -6457 4 30.7186 19.5182 17.7453 7.89699 4.38367 -1.56912 -6458 4 29.8579 20.5689 17.0557 -25.7709 36.069 4.20145 -6459 6 21.3137 21.0352 23.1207 17.1515 -0.95565 24.203 -6460 4 22.2175 21.149 23.495 -16.5785 2.35003 -9.75668 -6461 4 20.7278 21.0809 23.8918 1.9436 3.71589 -4.02445 -6462 6 32.3543 0.425745 25.2542 2.91189 -3.53517 -15.1456 -6463 4 32.2281 0.339162 24.2978 10.7775 -1.18886 4.59452 -6464 4 31.5305 0.792307 25.5362 -21.0885 6.89421 14.2132 -6465 6 26.144 32.4145 27.5224 1.5207 15.2147 0.716215 -6466 4 25.5792 33.1636 27.3089 1.00017 8.92672 2.49827 -6467 4 25.8737 31.7446 26.908 1.40169 -15.6227 -12.5261 -6468 6 31.6924 23.0038 41.4488 2.9891 4.25247 18.5975 -6469 4 32.5817 22.7219 41.7427 -10.6129 2.19465 -7.80737 -6470 4 31.0787 22.7203 0.234806 2.54762 2.31931 -6.22567 -6471 6 54.3675 17.8383 10.7129 6.79577 23.0573 52.4548 -6472 4 53.55 18.2477 10.4428 -14.1319 6.62767 -11.4304 -6473 4 54.6119 17.1874 10.0964 4.54612 -26.2874 -33.1105 -6474 6 15.4111 28.5567 8.624 -23.5209 17.7221 -14.2225 -6475 4 14.7074 29.0083 8.07604 23.4242 -18.2482 9.63627 -6476 4 15.9053 27.9212 8.07642 -10.4486 8.35345 -4.07335 -6477 6 21.923 22.3267 27.6697 4.39763 -15.072 3.90508 -6478 4 22.0757 23.261 27.7591 9.36727 14.8743 -6.39222 -6479 4 22.0153 22.013 28.5729 -4.02641 -8.91923 4.38679 -6480 6 2.936 17.0367 8.13301 26.8737 -0.816539 -9.93732 -6481 4 3.80704 17.1417 7.69888 -17.5309 -13.2134 -6.39661 -6482 4 2.90872 17.8246 8.6543 -8.08771 15.2208 15.3377 -6483 6 27.578 18.2783 3.98106 42.3665 -21.0645 -7.59535 -6484 4 26.9838 18.9866 3.87461 -35.9411 25.5305 -3.32845 -6485 4 28.3853 18.6252 3.56495 -11.0807 -10.9366 8.58166 -6486 6 24.7671 24.5333 8.4671 -3.55267 7.94183 -11.8318 -6487 4 25.0347 23.6359 8.24775 3.17664 -3.45343 1.13667 -6488 4 24.5725 24.5372 9.40731 3.34714 4.39373 0.466573 -6489 6 41.9868 30.4684 13.7801 28.6364 -21.7839 2.09937 -6490 4 42.9472 30.4515 13.6527 -5.43777 20.4489 -0.76134 -6491 4 41.8419 29.5153 13.705 -23.7897 6.87836 6.63004 -6492 6 15.6883 34.6775 41.5701 28.3539 0.757195 5.77675 -6493 4 16.4499 35.2822 41.5481 -1.40988 -1.74654 9.10263 -6494 4 14.9914 35.2483 41.869 -21.9895 7.57474 1.73196 -6495 6 11.1473 19.7636 40.5906 -7.01786 -3.24743 -12.0486 -6496 4 12.0915 19.8265 40.3679 -7.75233 -10.0339 3.8807 -6497 4 10.7912 18.9088 40.243 10.6872 10.1147 9.9033 -6498 6 47.4955 34.5311 14.2936 14.7321 -31.661 -1.66099 -6499 4 46.9342 35.3117 14.2317 -6.87541 2.2103 -19.2779 -6500 4 47.4978 33.9137 13.4978 -3.14061 27.4792 16.9676 -6501 6 12.3981 26.9866 28.4861 26.5251 -74.1409 -7.08463 -6502 4 13.226 26.8461 29.0045 -10.1246 11.0422 -0.548558 -6503 4 12.3843 26.0988 27.9797 -6.45597 45.1087 15.272 -6504 6 27.6352 16.207 39.8297 -11.2321 14.8168 6.13397 -6505 4 27.2166 15.4175 40.1567 -13.0977 -6.13948 14.8525 -6506 4 28.2209 15.8539 39.184 23.7477 -3.37658 -20.6816 -6507 6 33.4012 31.2187 27.2758 -9.34358 5.5086 -22.6345 -6508 4 34.125 31.7676 27.5967 0.31405 7.14405 -9.79506 -6509 4 32.8978 31.7031 26.5666 21.3968 -7.09575 17.214 -6510 6 39.0983 39.5786 31.9234 0.802497 -2.15341 -0.194752 -6511 4 38.8245 39.6381 30.9898 -0.836727 0.773065 10.2743 -6512 4 38.5517 40.2102 32.4207 8.13236 -5.11153 -2.10971 -6513 6 22.8875 16.5662 19.9556 -18.6429 -47.4181 0.677292 -6514 4 23.2714 15.7467 20.3471 4.73069 19.3315 1.98369 -6515 4 22.0725 16.1814 19.5628 10.6014 14.9969 -2.71875 -6516 6 23.9725 21.8734 10.5896 -27.2099 14.1239 -19.8382 -6517 4 22.9807 21.8764 10.5048 23.1264 -0.860286 11.7265 -6518 4 24.1883 21.166 11.1844 -1.51334 -13.3572 20.4185 -6519 6 40.1791 25.4384 2.79385 3.27033 10.4385 -27.7191 -6520 4 40.1215 24.9503 3.60378 -1.57927 -2.0951 21.761 -6521 4 39.8421 26.3422 2.89187 -4.34677 -6.39915 11.9951 -6522 6 15.0222 19.7637 9.4145 -47.1416 28.5942 15.5409 -6523 4 14.7277 20.7258 9.2944 13.9352 -33.0223 -5.4956 -6524 4 14.1981 19.3167 9.80349 37.3596 11.4933 -12.2096 -6525 6 7.16734 24.8761 0.122492 -38.9593 -14.3052 4.78001 -6526 4 7.92262 24.7355 41.4818 28.9246 2.82935 -8.29154 -6527 4 7.37325 25.3267 0.937782 12.1222 2.94845 5.10402 -6528 6 43.395 10.8961 31.3295 35.6095 27.14 14.9602 -6529 4 43.8689 11.0333 30.4778 -14.9331 -12.4968 13.4948 -6530 4 44.125 11.0026 32.0067 -24.5429 -5.74221 -22.764 -6531 6 13.8447 19.0699 27.8622 -3.35019 15.2359 -6.83255 -6532 4 12.9833 18.7163 28.0985 -4.55464 1.4506 5.93475 -6533 4 13.7874 20.0538 27.8435 3.60016 -14.5834 0.921784 -6534 6 3.48728 19.5892 9.61273 -55.7314 7.48447 -10.4955 -6535 4 2.69835 20.0905 9.96963 22.9021 -19.0673 -4.76373 -6536 4 4.2501 19.9102 10.0538 23.4289 5.03115 15.3445 -6537 6 51.0169 19.4212 7.7195 26.3048 39.1054 -53.7154 -6538 4 50.748 20.2575 7.21364 -2.7273 -32.3506 28.7892 -6539 4 51.8579 19.2204 7.21263 -29.2082 -7.0208 18.9647 -6540 6 42.2149 2.6091 10.4112 25.8935 -20.0624 -18.8025 -6541 4 43.1623 2.45904 10.6444 -24.152 11.2038 4.82319 -6542 4 42.1853 2.33112 9.4647 -3.80011 10.6068 21.7004 -6543 6 30.7928 6.43901 35.1986 -21.6247 -20.8821 1.11778 -6544 4 29.8295 6.39304 35.3716 10.0359 5.79706 -2.44011 -6545 4 31.0478 5.50645 35.0814 0.649811 9.90023 -1.69835 -6546 6 52.8722 36.96 18.5947 9.01539 9.27494 -7.55423 -6547 4 52.0657 36.4448 18.5061 -12.9065 3.13675 2.3407 -6548 4 52.6935 37.8522 18.2226 2.03776 -15.609 7.12003 -6549 6 44.2018 6.29599 1.04883 9.29405 17.1768 7.51252 -6550 4 44.5044 7.06671 1.58929 -4.49779 -17.4812 -0.431191 -6551 4 44.952 6.10526 0.487985 -0.115844 -2.61588 -3.46335 -6552 6 42.1326 38.6047 31.1849 18.5327 -13.3283 33.8135 -6553 4 41.7834 38.9864 30.4106 -14.9936 10.8543 -35.8121 -6554 4 41.4904 38.8324 31.8627 -0.641051 1.33351 1.93 -6555 6 43.7219 12.8013 9.05519 -6.282 7.91343 -40.7352 -6556 4 43.3171 13.69 8.87718 10.3632 -22.6116 8.3507 -6557 4 43.9578 12.415 8.15014 1.61383 14.3586 37.3488 -6558 6 13.4062 0.438838 6.51561 -30.6084 29.4042 -0.600484 -6559 4 12.9719 1.14899 7.05573 20.0807 -17.3818 -8.1595 -6560 4 13.3782 0.782754 5.59696 2.59294 -3.03922 8.63079 -6561 6 16.1217 13.2907 10.2805 -3.10591 -25.3511 -12.454 -6562 4 16.8946 12.7568 10.5076 8.02861 4.25978 2.86397 -6563 4 15.5299 12.6092 9.88546 -0.135156 17.9383 7.81515 -6564 6 1.59113 8.48217 4.69745 0.410151 -22.2633 16.3582 -6565 4 1.97054 9.1194 4.11301 8.92831 16.113 -22.7699 -6566 4 2.26765 8.43533 5.38895 -6.97239 3.0759 6.50405 -6567 6 37.2935 1.72102 10.5172 -13.7439 -9.21578 15.0824 -6568 4 37.1042 2.64553 10.595 10.0955 20.4226 -13.0857 -6569 4 36.8105 1.41855 11.2983 8.13599 -13.5394 -0.658926 -6570 6 53.8411 9.88961 17.6933 -45.7386 -38.9159 3.57486 -6571 4 54.5353 10.0399 17.0846 27.4782 6.59889 -23.5339 -6572 4 53.3721 9.08338 17.329 10.482 22.3983 14.0606 -6573 6 45.4787 30.6173 15.8038 -24.3966 -4.27047 13.1326 -6574 4 44.7717 31.1876 16.1963 22.3351 -9.42651 -10.1125 -6575 4 45.1907 29.6979 15.9324 6.84487 10.052 -2.21901 -6576 6 39.9241 16.6394 33.8426 -26.8877 -6.37158 -14.218 -6577 4 39.1549 17.2016 33.5476 23.291 -18.1751 3.42158 -6578 4 39.818 15.753 33.3934 2.94846 26.4583 15.0268 -6579 6 32.8532 24.7638 27.9368 9.55773 21.8346 -14.3088 -6580 4 33.6229 25.0593 28.4772 -14.6217 4.84572 -15.4057 -6581 4 32.6055 25.4822 27.2751 14.9958 -18.2832 35.5187 -6582 6 7.86628 31.6164 24.1091 22.2934 14.9204 62.1634 -6583 4 7.77595 30.8628 24.7489 -5.82572 16.0022 -25.8365 -6584 4 8.17309 32.3545 24.746 -24.9312 -26.1857 -42.8493 -6585 6 43.5324 41.3356 15.8165 16.5067 -5.02973 0.188395 -6586 4 43.1944 0.320073 15.7896 -5.69638 5.43212 -4.38793 -6587 4 44.429 41.3992 15.443 -10.6291 -2.88383 0.315207 -6588 6 20.021 29.5505 33.1902 25.0419 -7.98688 14.3875 -6589 4 20.8911 29.4069 33.5992 2.6372 -12.3274 -8.42754 -6590 4 19.6576 30.1636 33.8147 -14.9588 14.7065 -0.197692 -6591 6 43.4056 21.4569 18.6265 10.2156 -2.1017 15.5441 -6592 4 43.0498 21.3696 19.5313 -0.699705 -7.60676 -10.3888 -6593 4 42.9844 20.831 18.0298 -12.2248 -1.50447 0.773582 -6594 6 3.43117 19.1215 18.408 34.3393 4.70286 11.768 -6595 4 3.22621 20.0564 18.4267 -2.18643 4.81974 -5.59269 -6596 4 2.60088 18.6799 18.3703 -20.3233 -14.3491 -1.28903 -6597 6 41.6742 38.1112 16.3299 0.384784 -42.0766 -46.2559 -6598 4 41.8939 37.3404 15.6708 -9.75075 44.1094 34.3099 -6599 4 42.3403 38.1083 17.0131 5.25517 -2.87066 6.28124 -6600 6 7.56339 36.3915 10.5048 -18.8567 -13.4705 -13.5944 -6601 4 6.70677 36.1596 10.0967 9.18231 15.0261 0.193132 -6602 4 7.92251 35.493 10.5558 6.04756 10.3771 12.1048 -6603 6 36.2642 19.1103 34.8187 -40.4108 -29.7457 -43.4097 -6604 4 35.4719 19.3187 34.2477 20.3247 -4.92751 27.2967 -6605 4 36.4213 19.8813 35.3193 7.80254 33.8099 20.7293 -6606 6 53.576 24.9483 12.6399 1.20561 -0.517111 -17.326 -6607 4 53.6619 25.9414 12.669 8.79141 -29.2645 -7.24265 -6608 4 53.913 24.5623 11.7782 -4.09912 18.2899 28.1509 -6609 6 31.6824 10.4618 21.0892 -21.9557 -25.3726 -8.81809 -6610 4 31.4281 9.67391 21.5915 5.84781 10.5911 6.7189 -6611 4 30.8909 10.5838 20.5303 11.506 8.60894 0.332243 -6612 6 18.1093 28.7861 17.1823 13.2379 18.2354 -13.1758 -6613 4 19.074 28.7105 16.9739 -24.5165 5.38082 5.29014 -6614 4 17.7652 29.607 16.728 11.5472 -26.6353 13.0333 -6615 6 21.6834 18.2239 36.88 17.2587 0.811675 -5.67627 -6616 4 22.5671 18.027 36.4721 -27.7349 -1.55215 19.1593 -6617 4 21.6367 17.7543 37.7464 -1.70499 5.95625 -12.509 -6618 6 25.0551 19.0348 34.2287 -62.1041 -5.07763 23.2016 -6619 4 24.7663 18.3443 34.8719 5.43786 16.9757 -10.9409 -6620 4 25.8827 18.7578 33.9618 64.2031 -27.8273 -22.1538 -6621 6 15.5709 13.019 5.5539 0.00735057 -17.6807 20.5563 -6622 4 15.9927 13.3293 6.36292 0.0692085 12.4919 -5.39058 -6623 4 15.4491 12.0681 5.73828 -2.05735 13.2604 -17.7033 -6624 6 54.47 41.6402 14.7959 12.609 -13.6787 23.2741 -6625 4 54.8097 41.4531 15.6947 -1.45983 11.4249 -10.5768 -6626 4 53.7709 40.9948 14.7271 -15.6812 0.146288 -8.92901 -6627 6 1.6639 26.4809 31.3827 12.672 -25.15 69.1319 -6628 4 2.55491 26.3764 31.7735 -12.447 -0.333387 -5.00094 -6629 4 1.81595 26.6127 30.4938 10.6163 16.8649 -70.5286 -6630 6 32.3417 37.2868 29.6843 -28.8191 13.9029 5.49332 -6631 4 31.5776 37.8992 29.8843 22.0104 -18.6347 -4.04342 -6632 4 33.1171 37.6855 30.0945 4.79121 1.59444 1.77014 -6633 6 52.7104 21.0422 22.8867 -25.9211 15.4876 17.6965 -6634 4 51.8895 21.5407 22.5959 27.9099 -16.7396 2.24416 -6635 4 53.1785 20.6742 22.1421 1.33026 -7.16251 -14.9349 -6636 6 32.7465 28.5808 40.5193 19.5614 -2.95666 4.13778 -6637 4 32.1272 29.2507 40.2236 -19.1805 -2.02865 5.11045 -6638 4 32.5793 28.3106 41.4408 -7.78706 5.87783 -13.0149 -6639 6 23.6078 32.0654 16.3528 6.52471 10.7856 29.7964 -6640 4 24.3701 32.0729 16.9793 -11.8963 -10.2614 -20.8491 -6641 4 22.8856 32.382 16.9256 -1.99185 -7.37994 -15.8659 -6642 6 37.5296 9.17182 29.9714 -32.9897 5.30306 10.5453 -6643 4 36.7716 8.86544 30.5111 15.5785 -5.70066 -5.7121 -6644 4 37.1221 9.9689 29.5744 15.1662 -5.45151 -1.53858 -6645 6 2.26386 24.3835 14.5546 6.71022 -7.72281 -24.2479 -6646 4 1.85963 24.0133 15.3587 -6.19133 3.33276 -9.20692 -6647 4 2.05254 23.8227 13.7642 -0.610841 12.6744 29.5344 -6648 6 27.3686 28.7935 24.7702 8.50672 -13.2399 -34.495 -6649 4 27.2338 28.4442 25.6457 -6.20833 -8.14759 12.6395 -6650 4 27.3624 28.0447 24.1031 3.25167 21.2409 25.246 -6651 6 16.785 2.54959 14.3094 -6.20571 44.0359 18.8502 -6652 4 17.7332 2.53792 14.3228 12.8455 -14.2273 -3.64568 -6653 4 16.4133 1.8101 13.8617 -1.35631 -25.1723 -17.3636 -6654 6 21.8048 39.8028 36.8143 34.4281 41.1875 6.43987 -6655 4 22.7768 39.6281 36.9504 -24.2083 -5.20947 -5.56999 -6656 4 21.4132 39.0119 36.5213 -11.0202 -42.2818 -12.3994 -6657 6 14.0639 6.48367 41.5586 -1.33856 -25.5903 -39.7582 -6658 4 14.9412 6.10051 41.3922 2.86672 3.38346 15.7648 -6659 4 14.0719 7.05039 0.399753 4.3465 12.2327 22.8772 -6660 6 14.5548 16.5075 9.32956 22.0841 -14.7784 -21.2506 -6661 4 15.3586 16.5914 9.87503 -6.36199 2.72911 -6.08794 -6662 4 13.8899 17.0883 9.65711 -8.71884 14.1475 23.1102 -6663 6 8.67066 23.4815 30.5556 -44.0195 -7.59097 13.7496 -6664 4 9.49671 23.6557 30.1334 33.8338 1.75787 0.0184994 -6665 4 8.69311 23.4014 31.5307 16.0679 1.7618 -7.5699 -6666 6 37.6567 2.07706 19.9993 -10.7882 4.4912 14.9507 -6667 4 36.977 2.26584 19.3592 -1.31755 -8.36894 -24.369 -6668 4 37.311 2.65872 20.6865 17.7477 -2.01295 10.0374 -6669 6 42.7201 7.55732 8.02256 37.7013 -31.8103 68.6738 -6670 4 43.2078 7.90139 7.31041 13.9641 18.3531 -33.1003 -6671 4 43.4713 7.36984 8.74143 -54.3005 13.1784 -34.8973 -6672 6 38.5678 29.6657 6.85728 10.4727 -7.97498 12.0381 -6673 4 38.5138 29.2192 7.70857 5.95943 6.40388 2.63109 -6674 4 37.7242 29.471 6.47402 -15.8477 4.38345 -15.5494 -6675 6 42.5297 15.7017 39.7864 -1.2311 2.72873 2.24862 -6676 4 42.7877 16.6334 39.6476 -7.55712 -4.9727 -7.52807 -6677 4 42.0746 15.3358 38.9963 17.4435 12.5166 7.69263 -6678 6 19.8571 7.43592 22.0545 -24.1472 -5.51637 33.4113 -6679 4 19.2244 8.12179 21.7601 9.35088 -5.78158 -2.10146 -6680 4 19.4596 7.11536 22.9248 14.2781 17.6372 -34.9907 -6681 6 27.4149 3.22069 12.5516 40.9266 14.4549 -35.8463 -6682 4 28.3021 3.29229 12.0821 -30.0356 5.19144 18.8294 -6683 4 27.3767 2.28812 12.7581 -5.67627 -4.82192 6.74426 -6684 6 34.4116 6.50186 34.3661 -21.9879 -4.07114 7.78674 -6685 4 33.6675 7.13398 34.4265 8.52018 -4.33452 -1.60522 -6686 4 34.0848 5.70903 34.842 8.55338 12.1797 -0.556276 -6687 6 9.89342 27.9558 39.7643 36.6491 -8.46867 13.0669 -6688 4 10.8456 28.0225 40.104 -41.9626 -4.51635 -15.7261 -6689 4 9.67004 28.8098 39.3873 2.34979 10.3628 -2.65954 -6690 6 50.5619 22.115 6.39208 17.1303 26.4748 31.0688 -6691 4 51.4904 22.4109 6.45725 -8.74694 -11.3909 -7.00891 -6692 4 50.1939 22.6078 7.15954 -8.62199 -11.7106 -16.757 -6693 6 47.1151 11.4881 30.0373 19.0993 -20.4412 31.5796 -6694 4 47.2481 10.8506 30.7795 8.25865 21.4973 -13.9376 -6695 4 46.3269 11.1564 29.6474 -26.9131 -5.13028 -17.9745 -6696 6 25.9416 28.4741 9.79918 -11.6773 -32.55 32.2578 -6697 4 26.8348 28.2861 10.1548 -13.4597 2.20587 -7.83095 -6698 4 25.3328 27.8368 10.2912 20.3964 27.2145 -12.4741 -6699 6 35.4384 36.5941 19.4416 12.9267 19.1414 22.694 -6700 4 35.4164 36.6623 20.432 -0.885856 -8.21646 -20.3497 -6701 4 36.1159 37.2681 19.2232 -9.51806 -6.29836 -4.59986 -6702 6 39.0948 17.8654 12.2958 16.402 12.2899 -6.89152 -6703 4 39.0474 18.8007 12.5965 -2.38328 -10.6878 -1.40665 -6704 4 38.4419 17.3626 12.7715 -16.1853 0.319976 14.0097 -6705 6 2.67108 27.1436 2.40101 -1.75759 -3.65761 -8.1759 -6706 4 1.9876 27.5644 1.84788 8.2175 -2.76418 4.2561 -6707 4 2.53155 27.392 3.3289 1.87867 -1.67129 -3.85288 -6708 6 12.3359 32.2055 21.5153 -21.7508 0.12991 31.168 -6709 4 12.6488 32.0797 22.4173 29.0853 13.2861 -13.6486 -6710 4 11.491 31.8094 21.7155 -17.148 -0.720271 -25.2422 -6711 6 32.8833 32.3716 8.45599 -19.6455 -21.472 -14.5807 -6712 4 33.4538 32.8256 9.05859 9.48117 21.6574 11.6239 -6713 4 31.9723 32.7028 8.50155 9.17651 3.82723 3.41156 -6714 6 12.6485 6.44458 31.9777 -6.29944 1.49663 15.4125 -6715 4 13.1578 6.35833 31.1835 12.9638 -3.65534 -14.9347 -6716 4 11.7474 6.25334 31.7296 -4.07419 -1.29291 -2.47195 -6717 6 41.3645 27.7433 14.0415 -6.01814 -18.8263 -25.007 -6718 4 41.8124 27.3175 13.2596 -11.5333 15.588 22.1217 -6719 4 40.3975 27.5756 13.9407 20.5065 3.01622 5.4742 -6720 6 6.60161 16.499 25.4489 9.93734 -1.87947 -15.8553 -6721 4 7.35848 15.8951 25.4583 3.3895 5.33583 -1.00098 -6722 4 6.02379 16.0419 24.8253 -6.53341 1.34025 8.2366 -6723 6 21.7786 39.2974 13.3607 -58.7317 27.2846 42.4257 -6724 4 22.3848 39.3902 12.6828 41.4687 -6.70168 -50.5194 -6725 4 21.6228 40.2371 13.624 5.27297 -27.3266 2.34771 -6726 6 34.8408 6.01319 6.94562 -18.4641 -1.51643 5.78804 -6727 4 33.8445 5.90926 6.91888 31.3517 2.57767 -4.40922 -6728 4 35.1545 6.28252 6.0657 -8.54142 -2.93715 0.97402 -6729 6 33.0232 30.4151 33.1713 -30.7469 -3.39927 -39.9685 -6730 4 32.1382 30.6983 32.7963 25.7009 -18.3352 9.36685 -6731 4 33.1108 30.988 33.8978 7.7837 23.494 30.6115 -6732 6 15.4491 32.4129 12.2013 37.3068 -21.1945 16.3611 -6733 4 16.3823 32.073 12.2446 -28.3662 8.39135 1.47263 -6734 4 15.4224 32.8258 11.3561 0.313824 15.5191 -23.5701 -6735 6 12.6648 26.6033 21.3782 33.3074 -46.6123 -64.9668 -6736 4 12.0344 25.8976 21.5501 -12.6652 14.4466 17.403 -6737 4 12.7392 27.3327 21.935 -15.9008 39.2731 46.5109 -6738 6 47.0171 36.3051 29.9756 -14.9097 -3.99946 59.7783 -6739 4 47.3887 37.0247 30.5306 -0.120183 -5.44251 -19.0377 -6740 4 46.4147 35.8463 30.6463 22.302 11.6315 -30.1098 -6741 6 0.299553 12.7005 23.3858 -50.0817 10.3486 20.6993 -6742 4 0.55843 11.8154 23.133 6.9712 -0.709946 -9.28769 -6743 4 54.2783 12.6185 23.429 39.7411 7.62342 -2.706 -6744 6 54.1651 18.9185 21.5773 -27.3575 7.2555 -32.8787 -6745 4 0.055729 18.801 21.8215 42.2187 -10.4087 33.76 -6746 4 54.2632 18.7361 20.6344 -21.3012 2.13243 0.141772 -6747 6 25.7162 24.2884 23.7449 23.2111 -33.139 -2.25213 -6748 4 25.1836 23.5617 23.2944 18.61 24.747 21.927 -6749 4 26.5708 23.8587 24.0884 -36.4232 14.4676 -16.0896 -6750 6 11.8952 29.0236 26.8796 9.31073 -5.31833 9.58593 -6751 4 12.582 29.6684 27.1204 -3.01706 -1.21814 -5.31042 -6752 4 12.0145 28.319 27.5465 -5.16863 11.8863 -12.5997 -6753 6 48.0052 35.8598 10.6996 -18.0426 -22.591 -32.4945 -6754 4 48.7896 35.6794 10.1443 -7.64403 10.0758 9.7343 -6755 4 48.2747 36.3464 11.4544 19.4818 11.8303 20.3364 -6756 6 47.6544 29.8545 36.9555 47.7155 -39.8456 -42.9298 -6757 4 48.1196 29.373 36.1789 -16.9409 17.9192 43.9777 -6758 4 46.9556 30.2951 36.4995 -17.6283 12.0501 3.0439 -6759 6 7.32865 12.3513 10.6225 -20.3459 13.1064 -14.334 -6760 4 7.20572 12.8267 9.76478 7.03806 -14.4953 16.449 -6761 4 6.49136 12.5857 11.0944 24.1086 -12.0498 -8.15528 -6762 6 52.9256 15.9641 4.89737 -18.3283 -2.7411 -11.4996 -6763 4 53.001 16.1105 3.94443 2.36662 -0.713792 8.85774 -6764 4 53.8018 16.0105 5.25645 21.1817 2.44507 8.14275 -6765 6 10.6731 16.9472 34.6118 -36.7423 -4.99845 -47.4494 -6766 4 11.0533 16.8484 35.4724 -5.12202 -12.2675 26.0308 -6767 4 9.83371 16.4151 34.3796 40.245 18.7583 25.5995 -6768 6 25.147 31.0596 36.0152 -5.60145 -19.7687 -32.0201 -6769 4 25.7935 31.7656 36.1171 1.22463 2.78419 -3.72446 -6770 4 25.3418 30.5949 35.1615 -4.38154 15.6016 24.1358 -6771 6 34.0913 21.8858 41.4775 -4.76405 18.1665 32.5634 -6772 4 33.6625 21.1007 41.1787 -2.29922 -28.5955 -6.85504 -6773 4 34.6054 22.1733 40.7506 14.2114 10.2598 -30.2937 -6774 6 15.7731 30.0818 1.26798 39.0641 -13.3599 -49.0464 -6775 4 15.0823 30.4241 1.791 -23.818 19.5269 30.6537 -6776 4 16.2108 30.862 0.84325 -15.3415 -19.24 18.755 -6777 6 29.5302 27.8609 16.6022 -41.3972 -29.0796 28.0786 -6778 4 29.3307 26.8764 16.753 17.6765 42.2449 -1.67193 -6779 4 28.8227 28.3009 17.156 20.6394 -5.21731 -15.3441 -6780 6 39.6438 9.77612 0.552706 9.07327 13.2864 29.0584 -6781 4 40.129 10.5839 0.897097 -15.1313 -20.9808 -12.8857 -6782 4 39.4906 9.23066 1.36029 2.34479 9.54176 -15.0004 -6783 6 1.51524 31.8825 16.4089 -15.0842 0.567558 32.708 -6784 4 2.11225 32.2249 15.7721 17.5465 17.6302 -23.3114 -6785 4 1.56386 30.9485 16.2687 -0.663138 -25.5376 -6.36093 -6786 6 8.73078 39.8635 25.0545 2.96185 -34.7465 -17.9129 -6787 4 8.00321 39.5602 25.6169 4.07363 9.59654 5.53067 -6788 4 8.89391 40.7829 25.2096 -1.06312 24.7623 5.36493 -6789 6 42.3301 10.2778 9.76455 0.0249942 22.0437 -8.66619 -6790 4 42.035 10.1947 10.6715 6.68889 -4.55788 7.04955 -6791 4 42.6957 11.1854 9.68656 -1.85544 -15.7885 0.75259 -6792 6 13.241 7.61416 1.95847 -11.6175 -6.73398 30.6404 -6793 4 13.9892 7.82191 2.54806 -1.36929 5.6022 -7.80568 -6794 4 12.5695 7.22502 2.56499 11.7798 7.16895 -16.7116 -6795 6 18.7434 40.0583 14.2212 10.8937 -7.32712 21.4541 -6796 4 19.2417 39.7541 15.0131 -1.99408 15.6159 -18.1773 -6797 4 17.935 39.549 14.2832 -4.44855 -3.57314 -3.37042 -6798 6 20.0977 14.0454 38.5561 35.4799 -67.417 -7.49733 -6799 4 20.2641 13.632 37.67 -9.31749 10.6865 24.2255 -6800 4 19.7827 14.877 38.3297 -23.7972 64.5272 -8.60678 -6801 6 22.6565 28.8842 34.0588 -5.52315 8.37947 20.7951 -6802 4 23.0585 28.228 33.4828 2.77778 -4.34029 0.307399 -6803 4 22.9395 28.703 34.9822 0.354749 -6.57221 -14.6515 -6804 6 22.6874 4.70198 5.2328 -25.042 -9.90055 15.5414 -6805 4 22.1274 3.9708 5.56882 12.1557 -0.0327816 -16.8284 -6806 4 22.5434 5.31639 5.94822 12.9551 16.3877 4.62095 -6807 6 23.6492 33.9942 38.3998 23.375 33.8394 -43.1733 -6808 4 22.8011 33.6715 38.57 -44.227 -25.7371 21.164 -6809 4 23.4749 34.4069 37.5183 19.103 -7.547 16.6445 -6810 6 48.374 21.3549 17.2744 -0.727013 41.2048 -23.9838 -6811 4 48.2041 22.3166 17.0448 3.0192 -25.1475 26.0409 -6812 4 48.3509 20.9743 16.3868 -2.31832 -8.94154 10.8829 -6813 6 11.5758 10.9938 8.63273 -18.0621 42.8191 15.9647 -6814 4 11.6313 10.2483 9.25156 -2.19238 1.01339 1.87179 -6815 4 11.0547 11.7764 9.03291 21.9333 -36.8133 -6.7089 -6816 6 40.0924 28.1686 33.4857 17.1635 -5.37387 30.2378 -6817 4 41.046 28.3881 33.5354 -13.2006 -3.32107 -11.2861 -6818 4 39.7443 28.4933 32.6629 4.51627 6.28126 -11.3213 -6819 6 47.3837 25.6703 5.29617 28.7657 21.9065 -4.48206 -6820 4 46.461 25.5322 5.12569 -20.8862 2.51482 -4.893 -6821 4 47.6179 26.6114 5.08959 -12.3293 -15.1007 -0.275896 -6822 6 21.6517 35.2222 23.996 27.7917 10.3485 -3.89698 -6823 4 21.6311 34.5383 24.6593 -10.5502 -12.8786 6.64496 -6824 4 22.5954 35.4881 23.9966 -15.7417 2.23004 -2.6139 -6825 6 8.24409 41.4919 8.41354 9.22969 12.4334 -12.8549 -6826 4 8.15 40.8674 7.67873 -1.07657 -2.81584 5.48771 -6827 4 7.83543 41.113 9.18983 -1.52095 -3.2343 5.88405 -6828 6 16.4798 31.1082 22.2131 -4.24513 -17.8742 -2.35359 -6829 4 17.0752 30.8161 21.5077 -7.18137 4.28218 -7.0656 -6830 4 17.0564 31.1902 22.9696 5.97679 -0.907857 10.4567 -6831 6 54.7122 0.459271 28.3177 -16.7834 -37.5181 -6.57119 -6832 4 0.641958 0.15455 28.3975 4.09167 16.1916 -1.73275 -6833 4 54.5379 1.34634 28.6236 20.797 14.6923 4.72985 -6834 6 48.4477 15.3762 4.17752 -7.35125 -30.0531 -4.44848 -6835 4 49.1738 15.1128 4.81019 -14.8803 0.337287 -24.8229 -6836 4 48.0902 14.5922 3.6288 23.2827 31.0113 24.8784 -6837 6 34.3541 7.00171 40.4295 26.6588 -46.9533 -23.8625 -6838 4 33.6168 6.99428 39.8319 -14.4938 10.2897 -3.98371 -6839 4 34.9839 6.35967 39.9588 -19.3291 28.4488 24.7248 -6840 6 41.3507 3.37676 17.0028 -19.6969 -26.4955 -6.96819 -6841 4 41.02 2.66518 17.5936 5.53648 12.9859 -1.78552 -6842 4 41.944 3.90566 17.5305 10.5068 9.85924 8.73726 -6843 6 48.4427 20.685 14.5419 46.8112 -36.6841 26.4704 -6844 4 48.0177 21.3487 14.0717 -32.7597 47.8552 -32.6818 -6845 4 49.3877 20.9188 14.5227 -9.08294 -4.43462 -1.64124 -6846 6 52.4922 28.1277 37.1182 6.87418 8.84651 -10.3419 -6847 4 53.4134 28.4024 37.0408 3.12987 -6.6922 4.15316 -6848 4 52.2752 27.8963 36.2007 -7.47166 7.06161 9.73328 -6849 6 53.8774 18.5638 18.79 -18.2161 -77.5341 7.0005 -6850 4 54.7018 18.1425 18.5274 3.76082 -0.315502 -3.76089 -6851 4 54.0435 19.4528 18.7445 16.4561 77.5259 -2.54699 -6852 6 41.0011 39.1407 28.7879 -31.3786 -4.09579 71.7092 -6853 4 41.3911 39.2094 27.9661 28.9736 8.71878 -68.6315 -6854 4 40.0521 39.3021 28.7019 -2.27612 -3.41331 -6.23213 -6855 6 38.2743 8.75074 24.2285 24.5029 -7.68366 -19.8132 -6856 4 39.1919 8.60362 23.8621 -28.3827 4.68959 18.7737 -6857 4 38.3545 9.42009 24.9092 0.456349 2.35846 11.2764 -6858 6 2.99111 29.1615 9.6319 43.2691 -54.6401 14.341 -6859 4 2.5338 28.6319 8.99687 -12.0219 1.86489 -18.3516 -6860 4 2.58318 29.9865 9.638 -27.8835 49.5023 8.75508 -6861 6 27.5756 29.2755 18.3378 -4.01048 -11.7045 41.1881 -6862 4 26.7643 29.1652 17.8389 -11.7278 -2.11582 -9.62984 -6863 4 27.2839 29.0037 19.2864 20.9622 13.2114 -52.0932 -6864 6 11.8501 21.1733 10.1172 4.58733 -51.566 26.4002 -6865 4 12.2099 22.0246 9.9906 13.4732 33.828 -10.0235 -6866 4 12.4495 20.7458 10.776 -15.5727 16.0367 -15.8372 -6867 6 16.9004 32.2989 0.299881 0.133752 -22.2186 -6.7835 -6868 4 17.7029 32.7095 0.626455 9.4749 11.3588 3.4417 -6869 4 16.2118 32.9605 0.285394 -3.66285 20.1796 -4.1714 -6870 6 1.30064 17.4766 22.5523 32.9941 -5.4384 -19.965 -6871 4 1.2446 16.5356 22.2294 -6.1018 21.6977 3.5382 -6872 4 2.22906 17.8023 22.3815 -23.7878 -13.737 8.2324 -6873 6 41.5474 6.85538 29.3077 15.2611 30.5857 3.861 -6874 4 41.7413 5.96016 29.5642 -1.91107 -14.5726 0.121693 -6875 4 42.0251 7.37916 29.9826 -12.8279 -1.76094 -5.06557 -6876 6 10.5087 10.782 13.8577 27.0965 -13.6956 13.3978 -6877 4 10.7007 11.2274 13.0253 -2.16043 3.73872 -7.98734 -6878 4 11.2742 10.169 14.0479 -24.5023 11.0776 -3.5626 -6879 6 39.8289 15.4978 40.8346 25.2099 1.13818 0.661387 -6880 4 40.0487 16.0673 40.0758 -9.90377 -2.84048 2.34508 -6881 4 40.6829 15.4254 41.3222 -18.4618 6.82556 -4.74882 -6882 6 26.5164 19.6052 40.5088 -9.33805 1.61856 -11.7217 -6883 4 27.41 19.9717 40.4897 0.274496 -7.70925 5.49567 -6884 4 26.4209 18.9712 41.2422 6.64723 7.57269 5.06511 -6885 6 54.036 8.18782 13.7715 27.5212 34.9045 -2.54262 -6886 4 54.5316 7.46918 14.1378 9.61628 -19.3806 0.327355 -6887 4 53.1925 7.88218 13.5309 -39.9219 -15.1658 -7.5943 -6888 6 15.6949 25.3434 10.6718 -31.7842 -7.37099 0.0612328 -6889 4 15.1805 25.3333 9.84403 14.6699 1.30202 -4.92807 -6890 4 14.9666 25.3615 11.3188 15.8696 -4.15214 -3.47235 -6891 6 18.5987 3.44175 21.9294 71.7321 -9.69418 15.9409 -6892 4 19.6071 3.44542 22.1959 -64.1569 1.8736 -14.3483 -6893 4 18.6296 3.58776 20.9721 -7.77871 5.49431 4.81248 -6894 6 50.8883 20.6265 18.5187 28.1172 41.6529 17.9746 -6895 4 50.1573 21.1733 18.1958 -9.23125 -9.06144 -4.34911 -6896 4 51.4834 21.2842 19.0045 -23.468 -29.5191 -15.1667 -6897 6 53.3673 20.9038 31.2869 -12.1652 -1.18869 -3.23134 -6898 4 53.2409 20.9073 32.2442 5.88471 -1.70994 -0.407299 -6899 4 52.4717 20.8062 30.9053 11.2743 1.61965 3.90294 -6900 6 52.8102 27.6189 28.9831 -34.4743 -7.30027 30.0453 -6901 4 52.2848 27.4362 29.7987 1.4862 0.901255 -27.4551 -6902 4 53.4947 28.1361 29.3473 35.4934 25.3811 1.80223 -6903 6 33.3112 15.6955 11.3264 12.7704 9.00306 37.7013 -6904 4 33.4999 16.1238 12.2198 -3.00415 -23.4283 -28.8796 -6905 4 32.4346 16.0003 11.1059 -7.33456 8.94646 -4.12361 -6906 6 20.3875 26.8057 27.4813 21.213 -4.31231 15.2493 -6907 4 19.6396 27.3594 27.2578 -2.8557 9.66202 -0.370116 -6908 4 20.9667 27.2946 28.1279 -24.4059 -13.8952 -19.2793 -6909 6 8.54399 2.06163 14.1713 4.36483 17.1543 -0.299448 -6910 4 8.13837 1.20516 14.196 -9.47708 -17.773 2.17407 -6911 4 8.01805 2.60085 14.7902 6.78451 -6.83093 -3.12033 -6912 6 40.1002 7.56575 40.6778 12.4019 9.60944 38.6013 -6913 4 39.712 8.14959 41.3779 4.03526 -4.70584 -30.6789 -6914 4 40.8329 7.16354 41.1893 -8.78874 -6.51591 -16.4763 -6915 6 6.89044 6.83556 10.7869 16.1514 15.8461 -3.23426 -6916 4 7.31622 7.70217 10.5979 -16.164 -15.6489 3.8938 -6917 4 7.04178 6.69918 11.735 -3.2221 -0.411834 -4.21297 -6918 6 31.2643 6.58983 20.136 22.5576 -57.6677 6.94967 -6919 4 30.6637 5.92034 20.5005 -2.47046 2.78164 8.35653 -6920 4 30.7152 7.30056 19.9711 -35.0351 52.1138 -11.6241 -6921 6 54.5411 21.0454 27.2925 4.1013 -43.0328 84.8338 -6922 4 0.071192 20.2129 27.5399 -15.6737 30.1382 -21.2093 -6923 4 54.6532 21.3072 26.4181 12.1035 8.54749 -60.3726 -6924 6 4.75213 23.1508 16.2245 -49.4139 4.34438 -28.0546 -6925 4 4.2471 24.0009 16.1592 20.3634 -17.2761 5.59937 -6926 4 5.4972 23.3136 16.7675 27.2932 5.42097 22.4316 -6927 6 25.5515 11.0241 14.8358 9.2665 0.546345 5.2197 -6928 4 26.0976 10.3608 15.3182 -9.73323 12.0118 -14.516 -6929 4 25.8683 11.8947 15.1133 0.0398252 -5.90721 -2.6003 -6930 6 41.1974 41.7784 29.942 -27.7855 -7.97533 -10.6302 -6931 4 40.9203 40.8727 29.6366 8.3922 29.767 6.72032 -6932 4 40.4023 0.465719 29.8931 18.9924 -15.525 2.17149 -6933 6 52.2793 15.2936 41.6313 19.4314 -9.06844 -20.2837 -6934 4 51.991 15.9601 0.331443 -10.9307 10.9541 10.4228 -6935 4 51.6032 14.6231 41.5544 -13.8311 -6.7739 0.824233 -6936 6 37.7418 21.7882 37.8505 9.73059 24.2058 3.49681 -6937 4 37.8176 20.8655 37.6583 6.26781 -24.8638 0.142384 -6938 4 38.1128 21.8753 38.7352 0.661952 0.248137 2.40564 -6939 6 23.8436 9.73697 27.5598 -17.3101 -56.824 -21.1542 -6940 4 23.6823 8.97924 26.8635 13.0753 42.6322 38.797 -6941 4 23.3674 9.48178 28.3892 6.27388 8.11738 -19.7561 -6942 6 43.0121 28.0431 32.8137 29.5034 -18.022 1.83467 -6943 4 42.9555 27.148 33.1715 -16.7807 6.42622 4.12236 -6944 4 43.9561 28.0675 32.5908 -15.6612 14.0802 -2.62256 -6945 6 34.1451 21.2362 11.9042 -10.4207 -39.0944 -3.26361 -6946 4 33.7785 20.3444 12.1585 8.75301 27.3815 0.918114 -6947 4 33.7383 21.3833 11.0382 -2.92284 10.3561 2.31655 -6948 6 10.5016 31.8267 10.0873 5.91889 6.7472 5.74276 -6949 4 10.9186 32.6594 10.3946 -11.2895 -14.4825 -9.55855 -6950 4 9.99233 32.0033 9.274 9.03923 7.50024 8.93884 -6951 6 35.8744 37.1309 22.1208 9.07655 -0.20125 -37.6945 -6952 4 36.7757 37.5102 21.9868 -16.2539 -8.14962 7.83623 -6953 4 35.5893 37.243 23.0078 -0.963312 7.56509 34.0991 -6954 6 27.293 4.59192 27.4599 -62.9251 -2.97268 8.43797 -6955 4 27.8573 4.63875 28.2367 1.75868 -0.322614 6.7695 -6956 4 26.3027 4.46726 27.7774 60.9698 2.85981 -12.9146 -6957 6 39.0165 22.2861 10.6525 -25.2911 9.99335 20.5692 -6958 4 39.5938 21.9801 9.97437 16.8498 -5.94336 -19.6369 -6959 4 38.1468 22.3658 10.2352 2.38909 -7.32087 0.337973 -6960 6 30.765 39.1813 10.9358 -26.8864 17.0789 0.421318 -6961 4 31.7273 39.1993 11.0368 0.254075 -10.0442 -6.8497 -6962 4 30.3957 38.288 10.8473 24.5485 -0.522695 0.476538 -6963 6 44.5972 26.9475 2.20695 17.6159 -27.9211 -0.145864 -6964 4 44.8477 26.0903 2.61727 -13.9349 20.2639 -7.87324 -6965 4 45.3006 27.0404 1.55025 0.322606 15.9 1.66232 -6966 6 23.7817 14.549 26.4845 -13.1218 37.1912 -28.6876 -6967 4 23.5085 15.1786 25.7375 18.3344 -26.327 26.4977 -6968 4 23.2314 13.7794 26.3439 -3.10125 -8.02717 6.138 -6969 6 38.3349 13.3785 39.6531 51.0719 11.8768 18.627 -6970 4 39.1134 13.8424 40.1004 -28.3003 -20.0613 -21.9332 -6971 4 37.637 14.0102 39.7945 -20.9869 -1.09015 1.55638 -6972 6 17.9076 17.2343 29.3998 2.5182 -11.8623 9.07057 -6973 4 17.7005 16.8028 28.5679 -0.208052 -3.06359 -6.42367 -6974 4 17.2973 17.9612 29.4206 -13.3644 14.2602 6.84169 -6975 6 17.427 29.8312 9.9167 5.70667 9.14636 11.5297 -6976 4 16.5259 29.8398 9.63655 -18.5043 -5.93208 -2.5299 -6977 4 17.9097 29.6705 9.11934 16.3543 -3.78316 -10.6623 -6978 6 35.6302 6.05705 19.6249 -12.632 -1.17761 -30.1407 -6979 4 35.1756 5.57436 18.904 4.12491 -0.359791 14.6292 -6980 4 35.7342 6.9119 19.1826 9.40393 1.91765 12.7562 -6981 6 18.674 22.2857 17.523 8.42296 3.39096 21.1197 -6982 4 17.7402 22.4481 17.6821 -9.17854 0.615652 -6.61815 -6983 4 18.8674 22.3747 16.5992 -7.41694 3.44878 -20.9034 -6984 6 20.0258 3.81405 32.2871 -5.45876 10.2161 0.982716 -6985 4 19.684 4.03807 31.424 -2.67861 3.00481 -7.64614 -6986 4 20.9375 3.54321 32.099 -1.59169 -5.33194 9.42598 -6987 6 5.47094 6.98417 8.10987 -1.95658 -27.204 5.03178 -6988 4 5.85072 7.84658 8.088 3.96324 28.039 -6.11929 -6989 4 5.94584 6.55919 8.82772 -3.50663 -6.33739 10.9422 -6990 6 44.182 20.5312 25.5979 43.1361 -13.705 -19.148 -6991 4 44.6875 21.1042 26.1493 -15.9255 27.6084 29.7698 -6992 4 44.9726 20.2272 25.1253 -26.0739 -14.4287 -20.9555 -6993 6 43.9621 36.9892 17.8709 27.7049 17.1418 -9.42399 -6994 4 44.6647 37.4643 17.3692 -13.724 -4.61297 12.4448 -6995 4 43.6121 36.3808 17.225 -14.1002 -14.0328 0.985329 -6996 6 34.6183 10.1148 16.2555 -4.96303 14.2933 -37.1542 -6997 4 34.4099 10.1014 15.264 7.63186 -7.52385 38.4141 -6998 4 34.6455 11.0716 16.4378 1.03434 -4.81203 3.48645 -6999 6 23.6535 3.43617 1.32551 9.32991 -27.0385 -60.023 -7000 4 23.5361 2.47498 1.09872 1.70789 26.2755 24.74 -7001 4 23.8607 3.79652 0.414552 -11.3127 6.44054 37.9529 -7002 6 33.4225 38.9606 5.09116 -45.0556 15.9463 14.7537 -7003 4 32.9187 38.171 4.91655 10.2233 -24.4058 -4.43744 -7004 4 32.6531 39.5198 5.39063 34.9247 3.3662 -8.43025 -7005 6 22.5542 32.508 35.8091 -1.62577 21.6885 -22.4452 -7006 4 23.4313 32.1432 35.8321 13.5304 -8.64793 9.08541 -7007 4 22.6972 33.4304 35.4917 -7.91418 -12.6316 15.6694 -7008 6 32.4209 37.2696 13.8263 22.6153 37.4816 -15.7005 -7009 4 31.6314 36.8608 13.5507 -35.0264 -17.3769 -13.0658 -7010 4 32.7321 36.7183 14.5153 12.3601 -27.6025 17.2047 -7011 6 52.6048 12.7515 39.5965 -13.8302 -6.28036 -1.32475 -7012 4 53.26 13.3571 39.2655 9.70847 9.80763 -6.22213 -7013 4 53.0114 12.2827 40.3245 7.10516 -3.61819 3.538 -7014 6 28.8284 14.5654 1.23244 38.3097 18.383 -14.9432 -7015 4 28.2834 13.8143 1.34735 -23.3809 -22.0338 3.15251 -7016 4 28.3672 15.33 1.56727 -9.74512 0.414323 3.22557 -7017 6 1.45359 32.4205 23.3989 -1.05001 -40.1011 -18.1189 -7018 4 1.47013 31.5606 22.9188 -1.41837 10.7967 19.8874 -7019 4 1.97354 32.9442 22.8182 11.5552 29.203 -12.5869 -7020 6 54.3296 23.3325 28.9716 1.50467 4.34178 0.834044 -7021 4 54.2574 22.8567 29.7964 -0.193368 0.82753 11.1745 -7022 4 54.4723 22.6371 28.331 0.325397 -5.40149 -8.07104 -7023 6 14.3127 12.1509 35.6633 -33.5663 -10.8168 -13.6472 -7024 4 14.2878 12.7047 36.4184 6.74358 21.3133 20.6565 -7025 4 15.1756 11.8015 35.6107 35.8459 -8.25269 -4.05635 -7026 6 18.9986 6.53226 41.2771 -21.1361 -24.8418 -24.3627 -7027 4 18.366 5.78703 41.1105 9.63211 18.6573 18.8829 -7028 4 19.3119 6.48514 0.272589 3.11598 2.01554 11.5533 -7029 6 5.32991 17.8836 20.3428 -30.4167 16.0599 6.69424 -7030 4 4.7967 18.411 19.709 2.93149 -9.05217 4.33299 -7031 4 4.77097 17.8526 21.1546 15.0176 4.61027 -13.5236 -7032 6 24.7236 34.9657 30.1688 -3.59195 -26.0802 -14.261 -7033 4 24.7803 35.9013 30.0428 5.00342 21.1487 3.94382 -7034 4 24.6904 34.5809 29.2706 1.13339 13.2018 12.9935 -7035 6 31.868 4.6188 18.1813 26.0749 -11.7783 -2.21043 -7036 4 31.7807 5.26575 18.8694 -2.85928 14.415 8.06415 -7037 4 31.0011 4.54965 17.8036 -17.7428 -0.954819 -5.29079 -7038 6 8.70915 17.4782 5.92977 -5.10088 36.478 0.166614 -7039 4 7.99285 18.1665 5.8727 10.0003 -20.7449 -0.10219 -7040 4 9.53277 18.014 5.87919 -8.17468 -12.6369 7.06335 -7041 6 29.8448 10.9674 14.467 -9.24737 10.8237 6.24964 -7042 4 29.3518 11.4625 13.8111 -3.5417 -3.22768 -11.9456 -7043 4 29.8741 11.602 15.1948 7.6561 -6.41884 12.5924 -7044 6 48.7193 10.2987 32.5837 48.7914 -16.5053 -5.27468 -7045 4 48.664 9.84191 33.449 -1.5926 15.0761 -9.20872 -7046 4 49.6917 10.1556 32.2801 -49.2626 10.4163 8.33251 -7047 6 8.33128 15.6672 37.865 4.36755 4.12409 -33.9682 -7048 4 8.08142 16.0688 38.661 -6.22033 14.9054 48.1983 -7049 4 7.78443 16.1766 37.2488 7.82296 -4.92397 -7.06368 -7050 6 50.3849 3.07587 17.3306 53.0616 0.797084 -5.54454 -7051 4 49.9901 2.96071 16.4818 -23.7547 4.5323 -14.3202 -7052 4 49.831 3.21284 18.0832 -29.2444 4.71684 15.357 -7053 6 14.687 38.3962 10.9034 11.8452 2.26847 -28.7684 -7054 4 14.4993 38.5723 11.8231 -13.1425 0.700252 11.382 -7055 4 14.2628 37.5785 10.602 -2.45756 1.24341 13.1034 -7056 6 34.1174 6.37976 10.8168 12.9161 5.50138 13.5595 -7057 4 34.1292 7.23477 10.3416 2.23773 -14.4836 1.59416 -7058 4 34.9287 6.34152 11.3848 -14.7297 9.70771 -12.8953 -7059 6 7.1619 37.5492 17.6341 50.2032 -5.81562 0.15107 -7060 4 8.17599 37.5098 17.465 -47.7372 -0.307972 7.49553 -7061 4 7.05745 37.0565 18.4805 -8.53445 9.44148 -12.9936 -7062 6 51.515 11.3168 16.7982 -26.0757 5.86397 -27.0874 -7063 4 52.235 10.8459 17.1551 30.0977 -19.3818 20.7126 -7064 4 51.5008 11.0547 15.8562 -2.22905 10.0255 8.80825 -7065 6 15.6633 8.64974 3.19872 2.04011 -21.0584 -36.8111 -7066 4 15.359 9.2987 3.81038 -7.3063 19.0886 25.5551 -7067 4 16.1924 8.00887 3.67257 5.32849 -2.14206 7.59436 -7068 6 5.43671 21.4488 11.9213 -35.1135 30.2715 2.68526 -7069 4 5.1197 22.3031 11.5306 26.1226 -15.3225 -1.30607 -7070 4 4.71321 21.2794 12.5494 12.8867 -7.97314 3.40019 -7071 6 50.1888 24.041 37.9733 -16.5158 11.6838 -8.72192 -7072 4 49.5513 24.2503 37.2525 13.6843 -9.6942 16.9361 -7073 4 50.7608 23.3204 37.7156 0.52347 -2.66969 -5.08066 -7074 6 39.7366 11.2383 31.6978 23.7892 31.0409 -10.9794 -7075 4 40.3477 11.919 31.322 -8.85632 -23.7146 9.45819 -7076 4 38.8907 11.643 31.516 -11.7678 -2.00245 1.00495 -7077 6 26.6862 10.831 20.5846 -4.64528 13.8134 22.6501 -7078 4 26.37 11.3609 21.3584 5.46785 -6.26709 -23.7021 -7079 4 26.5097 9.94471 20.9062 3.28762 -9.42115 -6.7075 -7080 6 12.5617 17.5693 18.1619 57.3415 -16.6047 -35.4946 -7081 4 12.3732 16.6356 17.927 -10.1847 12.7431 11.2408 -7082 4 11.9536 17.9401 18.7496 -47.3477 6.23269 31.2745 -7083 6 47.7779 31.603 17.3345 -16.0229 -2.6295 -18.0517 -7084 4 48.4774 31.3981 17.9449 0.342859 -12.7175 10.4199 -7085 4 47.3751 30.7658 17.0144 6.51745 15.1025 2.87388 -7086 6 1.06661 3.38166 18.5387 0.482315 1.39351 -20.5486 -7087 4 1.47214 3.81044 19.3024 -7.19452 2.23946 8.83247 -7088 4 0.121217 3.21323 18.6865 2.92702 6.89788 10.7589 -7089 6 26.5916 20.3882 15.3141 4.05487 -19.1164 -7.10575 -7090 4 27.0276 19.5492 15.0037 -7.93965 16.9744 10.3813 -7091 4 25.6772 20.1067 15.4922 9.40368 -0.641397 -3.80974 -7092 6 42.0092 3.03717 36.7607 9.58516 7.42569 -27.539 -7093 4 41.472 2.27114 36.5289 -4.68032 -10.5632 12.6255 -7094 4 41.9749 3.27199 37.6769 -10.2045 -8.66607 25.0137 -7095 6 39.3197 22.4482 33.2161 17.1359 -6.1719 -1.11969 -7096 4 39.6777 22.5385 34.1471 -14.6651 4.73191 -34.7467 -7097 4 39.2891 23.3308 32.7977 1.66572 -7.01471 12.3298 -7098 6 18.4983 34.959 11.9233 -52.4092 11.8234 -6.15541 -7099 4 19.3311 34.9297 12.2931 62.358 -5.27325 28.8625 -7100 4 17.9525 35.2018 12.6795 -15.7268 -2.39727 1.11957 -7101 6 22.849 14.1156 0.206953 9.43339 -22.8796 20.8561 -7102 4 23.1273 14.7687 41.4941 9.338 18.1693 -9.76493 -7103 4 23.4344 14.2183 0.991573 -8.36464 7.13735 -11.7533 -7104 6 31.0127 16.6435 33.7717 -75.3989 -12.3916 10.6429 -7105 4 30.4261 16.8588 33.0132 20.7291 0.745933 12.1228 -7106 4 31.8948 16.7604 33.5238 39.9201 13.7608 -15.1754 -7107 6 28.4056 35.5121 5.54765 -4.91817 12.0412 -0.933493 -7108 4 29.0647 34.8486 5.74161 15.0982 -5.96625 -1.02933 -7109 4 28.8561 36.3656 5.44297 -1.6946 -6.58589 1.12865 -7110 6 2.06022 31.4415 10.6404 20.6415 1.38777 10.2498 -7111 4 2.4899 32.1989 10.2195 -2.44284 -2.19106 -3.22737 -7112 4 1.13111 31.6267 10.6164 -17.6565 -0.143118 -7.1498 -7113 6 5.95467 9.75858 21.3545 2.17354 8.87983 -50.8842 -7114 4 6.2643 10.5435 20.7894 -11.3634 -34.5597 22.4005 -7115 4 5.48441 9.14719 20.7121 9.8282 23.6666 23.1144 -7116 6 24.7866 26.6177 2.6661 -24.4024 -28.5469 2.9707 -7117 4 23.9476 26.6963 2.18158 9.10826 11.4817 -7.6186 -7118 4 24.6214 25.7954 3.1805 15.5163 19.2379 2.11057 -7119 6 45.7515 4.24664 18.6084 -0.948574 6.19926 2.59566 -7120 4 46.4738 4.91595 18.5123 -9.05862 -19.7882 -0.326833 -7121 4 46.0843 3.34349 18.421 4.31178 15.089 3.21664 -7122 6 4.45878 0.783326 15.9106 20.8465 2.39674 -2.22601 -7123 4 4.33336 41.7534 15.8294 -11.1347 -14.3847 -2.31303 -7124 4 5.37758 0.813141 16.2285 -10.0444 13.1447 -0.149196 -7125 6 2.44065 19.4988 25.3899 -18.2163 -19.9205 28.2208 -7126 4 1.89428 18.9873 26.0273 4.60516 17.0002 -8.33323 -7127 4 2.55045 18.8717 24.6878 9.48029 -1.77855 -17.0048 -7128 6 40.6027 8.48954 5.10826 -27.6355 -21.4881 -13.6167 -7129 4 40.6592 9.31425 5.57088 10.9479 16.5697 14.8472 -7130 4 41.3781 7.96424 5.30637 14.4251 2.68711 -2.52113 -7131 6 49.3092 22.3481 41.5186 -9.93734 74.0457 16.0776 -7132 4 48.4971 22.7919 41.1786 21.3857 -10.289 -0.267672 -7133 4 49.2285 21.4633 41.2985 -4.59952 -62.95 -16.8011 -7134 6 0.364483 40.9333 20.5966 -24.8933 -11.8265 -30.66 -7135 4 0.190818 39.9667 20.5681 4.35782 8.08342 1.06674 -7136 4 54.6936 41.3396 19.9676 13.1862 -7.22974 19.6204 -7137 6 34.8864 15.3279 38.0452 -17.1782 37.3505 -55.2903 -7138 4 34.2682 16.0872 37.9321 5.94042 -16.3876 6.60377 -7139 4 35.3697 15.4116 37.1797 -1.56134 -6.74346 24.1748 -7140 6 7.76223 25.9987 29.8652 25.7268 -8.51605 -4.95409 -7141 4 8.61839 26.4638 29.9588 -13.1921 -1.71741 1.7916 -7142 4 8.05672 25.0651 29.9772 -19.4202 16.3818 3.54783 -7143 6 40.7182 22.7954 20.4441 37.8127 13.8011 -33.8007 -7144 4 41.3586 23.4588 20.0133 -28.9149 -26.2189 23.8294 -7145 4 40.2017 23.2969 21.0583 -10.7099 15.3396 13.8501 -7146 6 37.6932 25.6399 36.0638 4.62997 10.0285 35.1853 -7147 4 38.3287 24.9236 36.1183 -2.20273 -4.01008 -9.65359 -7148 4 37.2914 25.6394 35.2107 -7.09628 -5.12362 -31.4654 -7149 6 5.46101 24.0014 10.2586 17.9799 16.5872 6.22131 -7150 4 6.04134 23.844 9.49543 -11.5162 -2.35388 5.85767 -7151 4 5.90746 24.7967 10.672 -23.415 -30.7572 -16.8601 -7152 6 48.4104 21.0451 38.1819 10.5351 27.9197 -28.7006 -7153 4 48.793 20.7803 39.017 13.2175 -6.38321 0.209366 -7154 4 49.1228 21.3802 37.5459 -28.8109 -18.4864 30.6779 -7155 6 15.2906 25.011 3.54101 2.70625 6.69817 -9.95824 -7156 4 15.4569 24.0555 3.50682 -9.52162 -0.514188 6.9158 -7157 4 14.6826 25.2483 4.2581 -1.83637 -10.9582 1.3864 -7158 6 46.3949 40.2718 20.0841 3.05266 -42.5213 0.389481 -7159 4 46.7282 39.319 20.1688 -17.5494 37.8624 -2.40649 -7160 4 47.138 40.8016 20.3323 14.2597 18.5668 -0.122304 -7161 6 34.6662 36.4732 0.324161 -52.0076 35.1593 -1.38074 -7162 4 34.82 35.9689 1.09464 17.4812 -18.6855 30.1307 -7163 4 33.7817 36.8781 0.601954 33.7085 -7.09846 -24.72 -7164 6 52.5968 8.00424 30.4116 -30.791 -5.83914 -1.44892 -7165 4 52.0396 8.66036 30.8559 12.8564 7.40177 -0.477247 -7166 4 51.9287 7.58179 29.8369 22.2614 -6.63703 0.63559 -7167 6 32.0772 3.86049 29.4688 -16.0025 -7.01815 -35.05 -7168 4 31.5382 3.03776 29.5615 20.8838 14.671 -1.22835 -7169 4 32.0904 4.03293 28.4798 -1.86833 -11.5506 40.3284 -7170 6 20.363 17.8245 28.646 3.47804 13.7512 -7.92665 -7171 4 19.5516 17.4966 29.0653 6.53113 9.74715 -6.36853 -7172 4 20.0825 18.3002 27.8308 0.555567 -8.90179 15.8758 -7173 6 30.4041 41.1634 41.0132 -16.7253 12.0993 -9.83452 -7174 4 30.5197 40.835 40.1072 4.71307 -5.7925 7.34595 -7175 4 31.1703 40.9637 41.5368 18.7313 -7.07732 1.06037 -7176 6 35.4542 32.8539 27.9215 21.6406 26.5455 -21.3275 -7177 4 35.1435 33.2362 28.7432 -6.21594 5.85967 7.97646 -7178 4 35.8745 33.6007 27.3754 -13.2283 -32.0923 16.9769 -7179 6 14.39 6.67952 12.731 -12.5058 36.491 0.424373 -7180 4 15.2321 6.28981 12.9462 8.74388 -6.1299 -2.75421 -7181 4 14.5067 7.66796 12.7988 -3.69921 -34.1177 -6.56265 -7182 6 41.8739 41.5433 20.319 24.4238 12.2951 6.29746 -7183 4 42.7192 41.2715 19.9184 -11.0628 6.38436 -6.30872 -7184 4 41.3184 40.7767 20.2955 -10.4459 -12.1473 -5.48062 -7185 6 46.3985 22.5739 8.8638 6.84921 19.3184 1.79378 -7186 4 45.8729 21.8991 8.42669 -3.07803 -12.5032 3.12866 -7187 4 47.1271 22.1566 9.33065 -8.50589 -8.34396 1.5145 -7188 6 17.4023 20.6526 13.9004 10.6995 28.5611 -11.4854 -7189 4 17.6978 21.6036 13.9579 -8.84666 -31.3302 7.07381 -7190 4 17.3123 20.5004 12.9448 0.490636 -3.23538 4.08121 -7191 6 8.20126 9.48382 13.3485 -42.4293 41.8522 17.2798 -7192 4 7.44487 10.0964 13.6076 19.5538 -29.8853 -13.4391 -7193 4 8.9576 10.0119 13.6277 13.7224 -9.45646 -1.54211 -7194 6 7.58554 14.8008 29.5824 -2.61798 9.90858 -2.64866 -7195 4 7.05733 14.3538 30.2458 -0.514214 1.68252 7.63674 -7196 4 7.01989 15.5029 29.2149 4.91731 -6.06465 -0.976267 -7197 6 29.5668 39.2268 22.6285 -3.66094 -2.39634 13.3419 -7198 4 29.8353 38.7557 23.4169 -4.20308 -7.76017 12.2752 -7199 4 30.3745 39.2765 22.1369 12.5997 4.36069 -18.8462 -7200 6 19.725 28.7952 8.44488 15.8543 2.58223 -4.45186 -7201 4 19.5131 27.8757 8.63421 -2.81313 1.38303 -4.16069 -7202 4 20.6983 28.808 8.54393 -13.7447 6.84799 3.59225 -7203 6 20.0995 21.6275 25.9249 -17.5249 50.4223 5.09745 -7204 4 20.7082 22.0204 26.5908 -8.84326 -18.264 -10.6066 -7205 4 19.3931 22.3347 25.9239 13.215 -30.9895 -3.48111 -7206 6 12.7711 16.1006 22.7986 17.0661 -2.75106 -3.7002 -7207 4 12.1316 16.7784 22.5952 -11.3059 6.43976 -4.8982 -7208 4 12.4647 15.3033 22.3372 -2.13756 9.04884 6.71194 -7209 6 7.09175 27.2069 17.991 -23.617 26.2366 -1.29155 -7210 4 7.8076 26.6007 17.9383 20.2011 -26.8554 -5.74897 -7211 4 7.19403 27.792 17.2318 3.33647 -0.0238245 -0.788587 -7212 6 32.3975 8.68618 34.8629 3.54321 22.8272 16.3539 -7213 4 32.7738 9.06402 35.707 -18.9002 -9.48773 -27.5474 -7214 4 31.4989 9.0701 34.6771 23.7457 -9.58556 9.46102 -7215 6 50.3515 28.2186 17.5351 -6.87553 0.519429 12.9107 -7216 4 50.2481 27.3572 17.999 6.5408 9.8464 -12.2276 -7217 4 51.0722 28.1417 16.8919 -2.26653 -7.3618 -1.59066 -7218 6 15.6741 32.1546 25.7968 -26.4348 -11.0143 -14.9159 -7219 4 16.4004 32.6083 26.1805 24.7846 13.6092 10.6573 -7220 4 15.1411 32.8481 25.3674 4.92309 -4.07512 11.5217 -7221 6 41.2877 22.001 29.6411 43.1174 -21.5596 15.2505 -7222 4 40.6305 22.5901 29.3541 -33.8214 23.827 -16.0773 -7223 4 40.8662 21.2212 29.998 -7.36398 -2.60921 4.02408 -7224 6 24.5416 12.7608 8.88206 5.17198 -11.9982 -20.3907 -7225 4 24.1774 13.5122 9.35398 1.69504 4.6425 -2.53241 -7226 4 24.2888 12.8675 7.94212 1.28664 -3.68024 15.0016 -7227 6 47.3025 20.1085 10.3977 1.21439 24.4816 37.2747 -7228 4 48.204 20.4596 10.4656 -0.7364 -8.12719 -10.3932 -7229 4 47.15 19.5905 9.61989 6.68365 -16.152 -23.0167 -7230 6 17.6916 14.2112 29.9613 0.736848 4.98565 -22.9932 -7231 4 16.8377 14.622 30.0672 -16.7241 9.37988 10.4211 -7232 4 18.1183 14.7557 29.2835 1.70081 -6.05446 6.16757 -7233 6 21.3481 34.5805 28.5342 -9.54463 9.82799 -20.865 -7234 4 21.5933 35.4178 28.0943 -1.05427 -4.62886 14.5387 -7235 4 21.7361 34.566 29.3968 13.4346 0.0141216 16.9261 -7236 6 35.1024 4.03924 4.01172 -45.5158 42.5484 12.3245 -7237 4 34.1858 3.89939 4.38295 32.1954 -12.7538 -7.33111 -7238 4 35.1016 5.02916 3.89259 9.91862 -26.8751 2.91657 -7239 6 29.9059 8.58368 22.6013 -13.5917 -22.6535 -48.6732 -7240 4 29.4773 8.30259 21.7189 15.3855 19.7125 42.6195 -7241 4 30.4378 7.8025 22.8052 -0.87874 9.41284 8.39762 -7242 6 9.78314 32.9658 15.9197 34.9354 -36.2496 39.6827 -7243 4 9.8463 32.0623 16.3137 -14.5131 14.3099 -26.4053 -7244 4 10.4229 33.3707 16.5321 -2.5459 17.7355 -14.0184 -7245 6 24.9212 14.2335 32.582 19.5351 -17.8621 25.1352 -7246 4 25.485 14.4356 33.3711 -14.9506 -0.509299 -20.0473 -7247 4 24.5508 15.0526 32.2925 -5.32053 16.7872 -6.18619 -7248 6 49.6539 21.965 26.2345 44.0267 25.2751 -8.97422 -7249 4 50.4399 21.435 26.5572 -22.3889 20.3635 -4.11669 -7250 4 50.0214 22.8598 25.9362 -18.5294 -37.2714 15.3372 -7251 6 39.2165 29.6282 28.7804 -1.72389 1.82743 -9.11301 -7252 4 39.3036 29.0201 29.5259 1.24025 -1.09654 1.55877 -7253 4 39.538 29.1266 28.0158 0.286751 -1.49672 5.82908 -7254 6 50.6899 34.7862 39.7499 25.3157 10.1005 12.0928 -7255 4 51.6472 34.6743 39.5192 -19.7186 -4.86584 -0.193213 -7256 4 50.1651 34.2508 39.1591 2.72681 -14.2758 -14.8682 -7257 6 29.2004 20.8742 19.5261 27.9811 -3.68804 20.7377 -7258 4 30.1466 21.1247 19.5553 -9.39276 -2.96688 2.79863 -7259 4 28.9246 21.1497 18.6738 -22.5466 15.5983 -24.0329 -7260 6 45.8438 1.42491 21.3861 -37.1737 6.40486 -10.0566 -7261 4 44.9885 1.11968 21.7285 6.97513 -0.0444158 -7.72874 -7262 4 46.4438 0.92117 21.8904 34.782 -15.8409 16.3481 -7263 6 26.1011 5.84859 12.9885 -16.9285 4.46913 -7.38549 -7264 4 26.5547 5.08441 12.6375 7.71787 -14.9735 6.0022 -7265 4 25.1614 5.66972 12.8036 4.71997 0.43883 -1.19571 -7266 6 9.00669 19.0403 23.7238 12.8928 30.373 -14.6892 -7267 4 8.06593 18.9071 23.7945 -12.9763 -5.98489 5.20443 -7268 4 9.0473 19.9093 23.2431 5.0983 -22.172 6.64837 -7269 6 47.6961 14.1782 40.0269 19.0377 9.97795 -11.4729 -7270 4 48.5222 14.3512 39.5239 -16.7083 -4.37767 10.6105 -7271 4 47.3795 15.0553 40.2888 -5.04524 -6.44815 -3.81417 -7272 6 47.9985 19.7874 0.500962 -66.9165 -27.0064 -39.4066 -7273 4 48.5513 19.9496 1.22397 26.1904 -2.55385 45.3318 -7274 4 47.2789 19.103 0.704655 34.6798 29.0788 0.973802 -7275 6 27.1606 39.6013 31.4318 -10.4761 -55.491 -38.6851 -7276 4 26.8926 40.2811 32.0159 -13.7359 20.3686 20.1783 -7277 4 26.3709 38.9998 31.2101 25.3937 25.349 18.055 -7278 6 20.7209 15.2822 27.3078 -0.805435 -7.71632 -8.78017 -7279 4 19.7876 15.3781 27.0487 8.25469 13.9731 2.34115 -7280 4 21.2532 16.0335 26.9925 -16.2498 2.55153 -4.46604 -7281 6 53.2722 3.12643 19.6849 41.3384 49.6686 7.26214 -7282 4 52.533 3.74254 19.7043 -8.02663 -2.92583 -3.0848 -7283 4 53.0086 2.23956 19.6703 -22.4403 -46.3419 -2.11618 -7284 6 40.7531 33.3786 24.0219 13.5521 -1.60379 23.9632 -7285 4 41.5067 33.1664 24.6167 -8.75803 3.71621 -14.936 -7286 4 40.1104 32.6626 24.1628 3.50492 2.6284 -2.95087 -7287 6 50.2066 37.8896 21.3771 44.4561 61.7722 -19.2089 -7288 4 50.9779 37.3435 21.496 14.3962 -14.5259 7.12428 -7289 4 49.4598 37.4098 21.5582 -59.0635 -51.549 13.7135 -7290 6 41.3233 2.3412 21.9924 -16.3503 12.7858 19.6024 -7291 4 41.3426 2.52207 21.0679 5.97541 2.4567 -21.4637 -7292 4 40.4663 2.75609 22.2585 17.532 -18.0725 0.252127 -7293 6 3.68867 21.2779 14.3383 -14.5707 42.5 -35.9941 -7294 4 4.12477 21.855 14.9587 9.56216 12.6885 8.47194 -7295 4 3.77328 20.4352 14.6935 9.76412 -50.205 23.6517 -7296 6 34.2782 11.1533 36.6146 -6.03132 -23.9347 13.7336 -7297 4 33.9924 10.5436 37.3334 13.9996 -4.78487 -21.5854 -7298 4 34.1172 11.978 37.0322 -7.62349 27.2634 9.28858 -7299 6 24.0533 21.9225 23.4615 4.73517 -5.47775 13.1649 -7300 4 23.9978 21.53 22.5886 6.00444 -6.53009 -8.74438 -7301 4 24.605 21.2935 23.9896 -10.4931 14.2472 -9.63662 -7302 6 18.8931 0.346665 4.41951 -1.70081 19.9518 7.76538 -7303 4 18.8368 41.3461 4.13842 4.04101 -8.25805 2.22226 -7304 4 19.3845 0.416823 5.25819 -4.2619 -8.11151 -12.0763 -7305 6 1.61167 7.82777 17.7295 14.4633 -7.55708 2.21629 -7306 4 1.68315 6.88308 17.5181 0.421421 7.02752 -3.81945 -7307 4 0.776664 7.94842 18.1735 -9.56642 1.01884 2.20602 -7308 6 9.88587 31.542 26.4865 27.4574 -58.0414 -32.6279 -7309 4 9.74723 30.8294 25.7579 9.18818 32.443 34.13 -7310 4 9.16596 32.1271 26.4328 -35.6644 31.0992 -1.66616 -7311 6 46.989 33.006 20.3636 -11.9681 -37.8677 44.1235 -7312 4 47.0707 32.5253 21.2626 7.56487 31.1056 -35.1941 -7313 4 46.435 32.3629 19.8924 4.61548 9.19147 -10.8851 -7314 6 49.5457 29.2916 21.3977 -38.7846 4.15079 -24.0209 -7315 4 50.3477 28.8236 21.2219 24.323 -7.55681 13.7085 -7316 4 49.5468 29.8542 22.1736 14.9668 -0.936193 10.2574 -7317 6 13.5153 31.8979 19.1528 13.8675 8.3184 29.6787 -7318 4 12.8458 31.9825 19.8587 16.0999 2.21739 -7.32054 -7319 4 14.3406 32.2634 19.5906 -25.0701 -6.26478 -24.6616 -7320 6 46.633 34.1066 16.9257 -0.036059 -36.1463 20.7227 -7321 4 46.8492 33.9929 15.9997 3.99258 8.43366 -10.882 -7322 4 46.9059 33.2223 17.3084 -4.9703 29.3867 -9.59361 -7323 6 19.7609 39.5392 2.42166 -7.20248 -0.896063 -14.0911 -7324 4 20.5606 40.0527 2.5788 -3.5749 4.99115 -1.28658 -7325 4 19.2738 40.0463 1.72337 11.6568 -15.7424 21.4794 -7326 6 16.5329 9.39795 28.3065 -12.6095 -8.72502 6.68605 -7327 4 16.4075 10.3536 28.3648 10.1088 3.80195 -3.74389 -7328 4 17.4502 9.20269 28.1082 11.2813 2.72217 -1.81406 -7329 6 3.0433 33.3643 8.96425 -4.92886 23.6682 -21.9772 -7330 4 2.41869 34.0757 8.74286 -2.57616 0.180013 17.6579 -7331 4 3.16376 33.0029 8.08154 7.55925 -16.3918 2.91827 -7332 6 49.6751 28.308 0.201579 -29.5359 7.30765 2.58258 -7333 4 50.5733 28.3754 41.8671 34.4717 0.327786 -9.88202 -7334 4 49.5726 27.4715 0.657175 -2.26504 -2.01296 8.34302 -7335 6 1.41619 6.84354 30.4994 -10.3235 0.0954103 3.42179 -7336 4 1.63397 7.74222 30.8225 4.19995 -13.4757 3.05915 -7337 4 0.761793 6.45905 31.124 14.5617 20.0187 -8.0296 -7338 6 19.7679 9.42131 33.717 -3.22882 -6.25654 -44.8315 -7339 4 19.9145 8.46604 33.7746 1.8774 1.59257 2.48781 -7340 4 19.5751 9.55831 32.7323 1.24521 6.76178 40.819 -7341 6 26.1724 11.919 3.61074 17.7641 10.7445 -19.8393 -7342 4 25.5356 12.1934 4.24073 -14.9718 14.8208 22.8097 -7343 4 26.0423 10.983 3.54915 1.55706 -20.7566 2.99847 -7344 6 33.2542 2.1444 18.2116 -1.15587 48.9982 3.93816 -7345 4 32.886 2.96086 18.6548 6.67205 -21.4839 -22.8104 -7346 4 32.6761 1.46025 18.493 -13.9253 -19.4899 6.26155 -7347 6 1.55797 29.1194 15.6221 -22.3111 36.2637 61.7506 -7348 4 0.853719 28.5449 15.936 -7.71843 6.28063 0.384394 -7349 4 1.90648 28.6788 14.9107 30.7784 -39.3832 -62.5327 -7350 6 41.7311 4.10421 39.5944 -40.7328 36.7616 -42.7174 -7351 4 41.3817 4.81242 38.923 27.6667 -38.3892 36.6931 -7352 4 40.9025 3.64602 39.8145 11.2401 -8.56921 5.26404 -7353 6 28.6823 41.7982 21.1955 47.2047 1.42594 -8.59686 -7354 4 29.177 0.720645 21.3267 -21.6507 -0.473723 0.486784 -7355 4 29.4617 41.2314 21.0003 -26.4876 -3.65191 3.02858 -7356 6 11.643 12.3982 35.4482 -35.2927 22.3423 -20.2863 -7357 4 11.5968 12.2307 36.3713 6.75035 -5.55932 30.2124 -7358 4 12.5522 12.401 35.2267 32.0712 -2.0845 -6.40416 -7359 6 9.80556 12.056 0.297197 42.0735 31.0338 -28.3715 -7360 4 10.6577 12.4693 0.65483 -33.0881 -22.384 -10.4034 -7361 4 9.20254 11.76 0.941289 -12.1624 -10.8407 36.4861 -7362 6 48.1632 12.393 9.2137 2.43833 7.21341 -5.5951 -7363 4 48.4522 11.811 8.50685 -9.57081 -7.25037 -8.94466 -7364 4 48.8896 12.3474 9.83523 7.41749 2.43397 12.8852 -7365 6 20.1331 24.378 18.9556 11.9182 2.36756 -38.9603 -7366 4 19.4372 23.8368 18.5171 17.2732 8.77886 9.60074 -7367 4 20.7988 24.6336 18.2364 -23.7637 -10.2166 26.3276 -7368 6 16.5494 31.2838 16.4573 -15.9423 3.69088 33.2062 -7369 4 16.5519 32.1922 16.7594 11.1434 16.9832 -11.781 -7370 4 16.1476 30.8867 17.2522 1.55385 -15.8871 -15.2552 -7371 6 1.78983 14.6435 36.2904 4.99553 5.58283 2.2492 -7372 4 1.04893 14.2282 35.8708 -13.8588 -3.35469 -16.6141 -7373 4 1.66905 14.392 37.2023 2.39459 2.07051 19.2387 -7374 6 4.37166 29.2153 29.5914 5.79168 20.1405 -19.3585 -7375 4 4.91557 28.7254 30.2154 7.17051 0.117226 5.39869 -7376 4 4.91513 29.9512 29.1891 -14.7291 -26.607 12.32 -7377 6 43.6969 0.237019 22.6594 -7.19613 -4.49497 -5.57098 -7378 4 43.0237 0.783547 22.2316 -12.2242 -6.81623 2.03469 -7379 4 43.4415 41.2053 22.5454 5.15142 14.113 -1.35906 -7380 6 52.5052 40.9917 27.2414 -4.0762 -16.2903 -30.037 -7381 4 52.8129 40.7577 26.3208 -10.5132 10.5144 20.9332 -7382 4 53.295 41.2999 27.6882 6.37269 9.42971 1.77711 -7383 6 25.5785 23.9088 27.7352 -29.163 -0.147769 2.09076 -7384 4 24.7169 24.3904 27.6009 26.0068 -16.0483 4.45096 -7385 4 26.303 24.4711 27.4736 4.98376 5.99744 -3.44082 -7386 6 23.1322 17.0409 33.3147 -4.87562 4.34963 6.5261 -7387 4 23.1435 17.5188 34.1474 -0.665908 -2.26574 -1.07751 -7388 4 22.9237 16.1327 33.5379 -5.85649 -9.89669 4.05086 -7389 6 2.9235 11.8719 21.3628 -62.5775 -31.8178 -28.2901 -7390 4 2.1985 11.2347 21.6738 31.4392 30.9604 -16.9464 -7391 4 3.51176 11.9111 22.066 35.7266 4.49799 37.8533 -7392 6 2.17958 4.14491 30.0321 9.06251 -9.53771 -13.2585 -7393 4 2.15165 5.09682 30.107 -1.56529 16.7016 0.150815 -7394 4 2.7299 3.97467 29.2422 -7.5281 0.377543 4.10315 -7395 6 26.6694 30.2855 13.4776 10.1196 11.7228 27.7054 -7396 4 25.7357 30.4785 13.6549 -0.51692 -11.2356 -3.98914 -7397 4 27.0778 30.3597 14.373 -6.55394 -4.70072 -25.9179 -7398 6 24.8731 30.8123 10.8246 -35.9544 -8.06722 -7.65859 -7399 4 25.2097 30.0125 10.4324 5.41746 -9.73411 -7.41209 -7400 4 25.6149 31.228 11.1936 31.2673 18.7081 18.3938 -7401 6 53.1638 24.1184 4.51161 -10.4445 -35.9395 21.0824 -7402 4 53.5233 24.7957 3.98549 14.2054 30.1141 -21.0763 -7403 4 53.9237 23.6117 4.81383 2.71167 2.31883 7.09562 -7404 6 24.8958 4.51213 23.9931 -29.6363 -43.6073 15.3227 -7405 4 24.1339 5.1036 23.9039 18.5944 16.8193 -2.99678 -7406 4 25.7258 4.88904 23.7461 22.8138 27.5954 -9.18982 -7407 6 34.6838 1.65591 41.2514 12.8053 -23.083 -29.6978 -7408 4 35.6244 1.45761 41.0729 -14.4971 0.421146 -0.177754 -7409 4 34.7301 1.99199 0.211928 -2.47028 17.9107 34.9925 -7410 6 13.312 19.5249 16.387 18.9594 -19.3284 17.3248 -7411 4 13.9333 19.1674 15.7225 -9.24732 -4.9188 0.52103 -7412 4 13.2597 18.8166 17.0929 -3.23838 18.5958 -24.3952 -7413 6 48.698 0.181353 20.409 -0.21633 -26.9433 -24.4133 -7414 4 49.103 41.5184 19.698 -4.34753 24.5911 30.5043 -7415 4 48.7986 41.623 21.2469 8.80211 1.41451 -0.511645 -7416 6 43.0644 27.7916 11.5133 -14.5871 -6.12813 -9.0892 -7417 4 42.6 28.0105 10.6776 10.2055 -1.97818 11.3293 -7418 4 43.4908 28.591 11.8257 3.55806 4.66568 -1.20709 -7419 6 25.6909 21.365 35.1834 16.6334 21.4278 -26.2382 -7420 4 25.8486 22.0441 34.4664 -6.54449 -15.4554 28.1071 -7421 4 25.5413 20.5536 34.6727 -4.24699 7.33591 15.2905 -7422 6 44.7232 4.60607 27.7619 9.66663 0.618053 -4.25407 -7423 4 44.3234 4.00717 27.1079 -6.11804 2.34462 0.765623 -7424 4 44.3971 5.50639 27.5932 -3.06611 -6.30885 -0.545657 -7425 6 41.2897 11.4432 34.2066 -9.61739 21.0206 -8.56292 -7426 4 40.6842 11.5664 33.4581 3.14959 1.41378 -1.0752 -7427 4 41.1924 10.5195 34.3892 0.589219 -23.8889 7.33677 -7428 6 19.897 36.6492 2.04794 -32.5825 5.5481 -21.6378 -7429 4 20.6399 36.2361 2.4987 10.0826 10.558 0.716761 -7430 4 19.9026 37.6342 1.97212 14.9366 -15.8518 15.2433 -7431 6 27.4836 4.66736 6.35028 2.97665 -65.4375 -50.0742 -7432 4 27.6123 3.82169 6.79207 -3.46759 -4.72632 -9.32934 -7433 4 27.4741 5.24116 7.04108 -4.39889 64.7262 58.0755 -7434 6 16.8382 30.7844 39.9326 10.6925 -56.0648 15.7324 -7435 4 17.0186 31.2572 40.7403 -2.33579 15.7179 12.0581 -7436 4 17.0831 29.8382 40.1617 -5.04661 27.4351 -11.6424 -7437 6 51.1641 15.1933 16.3324 21.7581 16.0625 -9.079 -7438 4 51.121 16.0888 15.8936 10.5188 -25.5533 9.6052 -7439 4 52.0677 14.7794 16.1385 -37.3149 17.1399 3.28502 -7440 6 49.9904 21.2241 35.9744 20.9503 -33.7397 19.542 -7441 4 49.3714 21.5088 35.3291 -23.4605 10.1211 -23.8745 -7442 4 49.9121 20.2362 36.0002 2.40052 26.2853 0.00810801 -7443 6 34.428 0.14016 5.66944 -7.82493 37.3161 8.31948 -7444 4 34.304 0.843366 6.34479 2.68801 -11.9822 -16.4886 -7445 4 34.2591 0.582485 4.80419 9.04141 -16.6905 11.7821 -7446 6 48.3182 11.536 19.8764 -48.9228 13.3726 26.2823 -7447 4 47.7285 11.3649 20.663 34.2262 -2.74449 -19.9886 -7448 4 47.7235 12.1441 19.3775 23.4884 -14.873 -2.11476 -7449 6 4.19152 39.4305 13.3555 27.463 28.0369 44.5079 -7450 4 4.88401 39.7456 14.019 -21.6239 -15.7277 -33.754 -7451 4 3.37287 39.6897 13.8148 -3.76347 -10.7833 -11.4512 -7452 6 8.74995 16.191 8.53596 -5.05856 2.64204 -21.058 -7453 4 8.7323 16.8633 9.22906 0.669847 -0.203387 -6.91741 -7454 4 8.69158 16.6347 7.64451 3.76071 -7.46014 24.9197 -7455 6 29.0285 14.2822 26.5262 -5.84817 34.0816 17.5192 -7456 4 29.0044 15.2824 26.745 3.30971 -49.1818 -9.92417 -7457 4 28.1563 13.9159 26.7584 2.39554 12.59 0.416474 -7458 6 27.3852 14.5292 8.14264 -25.3608 8.37865 0.80053 -7459 4 26.4121 14.3996 8.08331 21.4517 0.6706 1.76752 -7460 4 27.495 15.4908 8.29449 3.73212 -17.2528 -1.50339 -7461 6 14.1265 27.2071 32.922 33.1666 19.82 -10.1122 -7462 4 14.9257 27.349 33.4618 -9.56175 -2.66902 -6.75133 -7463 4 13.49 26.8422 33.5082 -21.5238 -13.7689 15.9353 -7464 6 31.6534 35.7886 21.2701 -36.804 -37.663 0.546332 -7465 4 32.1208 36.3742 21.8378 9.4961 28.0075 13.3964 -7466 4 30.8651 35.4592 21.7961 25.8489 11.2411 -16.1565 -7467 6 54.2152 28.7064 16.8886 2.86275 11.2554 8.9719 -7468 4 53.522 28.534 16.2345 -0.160695 -4.94794 5.34414 -7469 4 54.0581 29.6054 17.2296 -4.68599 -7.1814 -6.41975 -7470 6 9.06113 5.28333 17.1437 22.8853 4.22723 -20.1716 -7471 4 9.91678 5.17464 16.6036 -37.1561 0.754494 23.2593 -7472 4 8.77829 6.22091 17.0709 7.89423 -13.2605 2.73354 -7473 6 29.6746 9.78112 26.5507 33.4729 -21.3737 16.6755 -7474 4 30.5187 9.26436 26.5785 -19.9088 14.0899 -1.39861 -7475 4 29.3838 9.79264 27.4752 -2.64272 0.36338 -0.771294 -7476 6 44.0224 31.1718 32.1785 -15.3292 -7.28341 -3.2168 -7477 4 43.2245 30.9732 32.7283 18.2556 6.42044 -7.39667 -7478 4 44.6106 31.7763 32.6435 0.791193 1.46174 13.5451 -7479 6 53.5017 3.62335 25.1421 -16.9806 -9.67341 -1.19546 -7480 4 54.1073 4.37139 25.2408 5.33888 -0.871569 -8.36925 -7481 4 53.4976 3.25444 24.2353 14.6771 10.8199 10.1585 -7482 6 12.4523 22.8699 3.37515 20.8696 32.0548 51.3092 -7483 4 12.8715 22.0381 3.24611 3.69599 -28.8916 -15.1378 -7484 4 11.7545 23.0169 2.77653 -28.9409 -2.61743 -32.5554 -7485 6 39.4163 29.6883 0.716973 23.965 14.7498 -4.51132 -7486 4 39.9876 29.0776 0.254063 1.0023 1.05593 -7.22278 -7487 4 38.7356 29.138 1.03498 -27.9991 -12.2746 11.9106 -7488 6 13.7523 37.8126 23.0391 19.0421 33.8918 15.0049 -7489 4 14.5819 38.1972 23.3968 -5.92503 -31.5844 -9.82397 -7490 4 13.2717 38.649 23.0641 -23.8611 -10.9328 -14.9892 -7491 6 33.3489 41.2294 0.00543 12.0778 19.0207 4.12226 -7492 4 33.8966 0.076279 41.545 -17.8654 -16.3366 26.9287 -7493 4 33.5442 41.0956 0.968664 -4.79835 4.63337 -24.688 -7494 6 15.7246 3.52046 6.32841 10.9162 -8.85937 41.3038 -7495 4 14.9211 3.23468 6.78447 -0.787572 2.77727 3.3355 -7496 4 15.4617 3.69817 5.45032 -11.5336 7.63209 -33.5323 -7497 6 27.7759 30.762 5.08277 5.52432 -34.0682 -16.3389 -7498 4 28.5998 30.6312 5.57248 -10.7862 7.58152 2.34054 -7499 4 27.6688 29.856 4.68367 -5.5152 22.3618 6.77689 -7500 6 13.3283 7.58248 23.3427 28.3072 -1.43357 14.0598 -7501 4 14.1858 7.86415 22.9596 -10.8574 -4.57961 9.77565 -7502 4 12.7328 7.50745 22.6198 -18.1881 0.025746 -17.8687 -7503 6 38.3062 37.3234 27.9933 -3.63803 -3.21002 47.0561 -7504 4 38.1692 37.3862 27.0673 7.32148 -0.46048 -39.7323 -7505 4 39.0245 36.7163 28.2248 2.26391 -1.88339 -8.27891 -7506 6 35.8197 12.5511 12.093 -4.81482 -18.6185 14.0356 -7507 4 35.6024 11.6096 12.0486 2.81432 1.21601 -0.921604 -7508 4 36.2712 12.7262 11.2865 10.3444 9.98072 -18.0035 -7509 6 52.1161 23.0926 41.2793 27.7225 -3.87143 -59.8556 -7510 4 52.4049 23.0393 40.2964 5.44511 3.0042 51.4604 -7511 4 51.1968 22.9093 41.149 -26.7248 -2.75497 17.7375 -7512 6 39.5495 11.6692 16.6079 -1.17202 -14.5197 -14.1262 -7513 4 39.7784 10.7494 16.7482 7.99576 -7.98247 -12.1867 -7514 4 39.4663 11.9292 17.5115 -4.38422 20.0879 20.6825 -7515 6 0.676885 9.01905 7.96736 13.1741 22.7352 -22.4375 -7516 4 54.8016 8.92404 8.29683 -40.226 7.08621 2.19233 -7517 4 1.10058 8.31451 8.38908 28.7575 -30.4684 16.9583 -7518 6 42.3311 28.7401 39.4661 13.4879 80.877 11.2525 -7519 4 41.6603 28.5849 40.0851 -34.7426 -11.2721 27.5092 -7520 4 42.5519 27.921 39.1558 20.2132 -66.4303 -37.3003 -7521 6 38.7411 30.2829 16.2738 12.7671 5.32399 18.4704 -7522 4 38.9183 29.8748 17.1496 -6.87016 4.31697 -11.6029 -7523 4 39.4059 31.0046 16.2472 -14.9795 -12.5163 -3.03567 -7524 6 7.58764 18.0405 0.648325 -47.6574 -19.7672 20.3632 -7525 4 7.12731 17.6217 1.42737 12.1211 9.19751 -27.5752 -7526 4 8.47251 18.0259 0.938181 42.7013 4.4664 8.86021 -7527 6 33.7296 34.5938 24.1405 -3.484 -2.51034 -8.30179 -7528 4 33.5251 35.3309 23.5532 1.13599 -1.72579 4.26838 -7529 4 33.8994 34.9649 25.0137 6.47563 -1.63099 1.09862 -7530 6 16.0166 40.0494 39.5956 -28.3908 0.329345 -1.37751 -7531 4 16.9382 40.2323 39.4336 17.0381 0.329941 -6.23981 -7532 4 15.5262 40.0524 38.7513 12.3223 -0.591958 2.13513 -7533 6 4.49229 37.1333 21.8385 27.3085 -52.2253 -58.5501 -7534 4 4.66683 37.716 22.5264 18.8147 38.5231 40.56 -7535 4 5.37915 36.8768 21.3985 -41.7208 12.465 14.7942 -7536 6 39.2691 20.1288 31.3316 -12.2203 -9.20146 -18.9279 -7537 4 39.1503 20.9416 31.8094 1.95478 16.2675 16.373 -7538 4 38.6746 20.1785 30.5607 4.99665 9.53371 7.24081 -7539 6 28.5508 6.16368 32.0494 2.8072 -5.52183 -6.01527 -7540 4 29.3622 6.49582 32.4253 9.65206 -4.8896 7.96618 -7541 4 28.0782 6.98121 31.874 -4.3704 -0.58129 1.95425 -7542 6 9.33595 11.3298 38.1871 -32.8874 9.84086 11.8913 -7543 4 8.64445 12.0594 38.2922 21.8008 -26.7714 -10.0524 -7544 4 8.88851 10.5546 37.784 7.69784 20.5749 -6.72048 -7545 6 41.6095 10.4782 6.86111 8.23897 -6.62675 34.9169 -7546 4 41.7694 10.1037 7.78655 -4.1265 15.4661 -32.721 -7547 4 41.7821 11.4382 6.90291 -3.49967 -11.9299 -5.09907 -7548 6 3.12867 28.1157 17.6206 15.6267 -45.6796 29.9202 -7549 4 2.63816 28.6493 17.0564 -29.7899 29.6493 -43.0934 -7550 4 3.59757 28.7421 18.155 7.53462 9.15161 11.5693 -7551 6 39.3499 12.2397 19.2529 -23.7838 14.9837 13.9357 -7552 4 39.2457 13.2286 19.3464 7.91877 -27.4185 3.68816 -7553 4 38.6075 11.8387 19.7677 15.6586 5.94778 -12.3856 -7554 6 2.78491 9.11686 31.712 -26.5503 -22.4732 34.9375 -7555 4 3.2978 8.41451 32.2045 -9.27186 19.8876 -17.5091 -7556 4 3.27525 9.5282 31.0263 27.6548 6.40843 -16.0242 -7557 6 47.0993 34.3062 24.1668 40.213 25.5871 3.96938 -7558 4 47.8652 34.9011 23.9742 -8.40565 -28.0457 9.8184 -7559 4 46.4391 34.8642 23.795 -37.1496 -1.08965 -6.28687 -7560 6 41.29 35.6184 9.54316 -30.0867 29.8286 7.21591 -7561 4 40.3249 35.7138 9.72984 17.4159 -14.0538 -3.31523 -7562 4 41.5907 36.542 9.70742 6.71087 -21.892 -10.0971 -7563 6 20.4656 31.4513 3.14505 -29.4444 2.15246 21.5865 -7564 4 20.9799 31.2087 3.9226 8.79014 -0.482357 -2.15716 -7565 4 19.5517 31.5947 3.51954 23.5031 -1.57475 -20.844 -7566 6 33.2192 17.965 24.7971 19.8065 25.0952 18.1835 -7567 4 34.1598 18.0267 25.093 -16.2559 -11.4614 -7.96855 -7568 4 32.9244 18.9016 24.8301 -6.14071 -21.8705 -2.46334 -7569 6 40.1545 39.892 35.7566 -26.4952 1.03865 35.1005 -7570 4 39.554 39.7115 35.0283 3.12548 3.08468 -2.58895 -7571 4 39.5538 40.0617 36.55 23.7339 -1.54775 -30.4418 -7572 6 4.86493 34.7165 16.5037 -1.18866 4.83191 -8.79653 -7573 4 4.98021 35.6639 16.3239 -2.48039 -7.07182 -3.79473 -7574 4 5.57973 34.27 16.0245 9.17482 -2.77359 5.31354 -7575 6 19.1203 11.0308 26.5475 4.8369 12.9311 -1.38474 -7576 4 19.2948 10.8261 25.6303 -10.7878 -2.53157 -9.81197 -7577 4 19.6222 10.3806 27.0285 -0.932765 -12.0852 11.9627 -7578 6 54.013 13.9266 34.7866 19.735 -12.4153 18.0126 -7579 4 53.1377 14.0488 35.1524 -10.4928 -1.09871 -13.0068 -7580 4 53.982 14.1469 33.8595 -3.66316 10.2302 -11.2602 -7581 6 1.83695 20.649 5.20524 25.5491 14.9074 -17.0883 -7582 4 1.35705 19.8566 4.90021 2.5306 9.60758 -2.11708 -7583 4 2.48138 20.9466 4.48633 -27.5057 -15.388 16.1855 -7584 6 22.2484 0.089789 14.2543 15.3573 -11.1234 0.0573231 -7585 4 21.4821 0.622149 14.4313 -9.66168 8.29964 10.305 -7586 4 22.7606 41.8363 15.0657 -14.7435 5.42194 -5.09127 -7587 6 4.9437 7.03924 24.7311 13.2528 -2.19763 7.32506 -7588 4 4.13251 7.3412 24.2993 4.98795 -3.92941 -4.4547 -7589 4 5.31694 6.26419 24.274 -9.7854 5.58222 5.45409 -7590 6 41.4768 20.8727 34.9433 -10.8141 32.3245 17.6117 -7591 4 42.0721 20.1596 35.0936 18.2074 -21.2429 -2.25611 -7592 4 41.5511 21.3995 35.7803 -3.93981 -14.5735 -18.4651 -7593 6 28.2063 1.73787 31.7361 2.56856 -6.63991 -21.6427 -7594 4 27.5833 1.04583 32.0206 5.931 11.5306 2.70007 -7595 4 28.427 2.28487 32.4907 -6.15569 2.19681 12.1249 -7596 6 16.8959 27.3728 36.9936 3.36683 -9.46076 -21.7251 -7597 4 17.1861 28.0765 36.4018 -0.835984 6.87178 9.62195 -7598 4 17.1491 26.5677 36.4964 -8.72142 5.45523 11.8618 -7599 6 26.8172 38.095 8.33253 -7.04389 15.4319 43.7153 -7600 4 26.4231 38.1886 9.22965 13.1827 16.4204 -18.9623 -7601 4 26.752 37.1697 8.26194 2.82704 -45.8494 -18.5449 -7602 6 26.6605 33.8021 23.2109 -14.7721 -8.40788 6.86704 -7603 4 27.1437 33.2455 22.6071 1.71839 -3.83047 -13.3917 -7604 4 27.3181 34.0928 23.8234 13.6598 11.6313 12.8928 -7605 6 10.2089 27.1103 30.2249 26.5091 -20.839 -19.8889 -7606 4 10.2296 28.0525 30.305 -4.35446 23.414 7.17464 -7607 4 10.909 26.9135 29.5485 -17.3927 5.996 19.4297 -7608 6 47.8678 12.6068 5.01236 10.3402 17.2727 14.3835 -7609 4 48.2471 13.4466 5.34357 -15.5974 -13.1618 -9.91905 -7610 4 48.2827 11.9587 5.58273 0.760146 -12.24 2.37579 -7611 6 53.3401 24.5564 22.1447 -33.4845 3.13007 15.4457 -7612 4 53.2868 24.6175 23.1082 -8.50106 -5.88574 1.47389 -7613 4 54.2491 24.6404 21.954 37.9576 4.9603 -12.0283 -7614 6 29.4115 10.751 19.3682 47.3718 16.1602 -3.46693 -7615 4 29.23 9.95501 18.9095 -1.62259 -22.6341 -18.5903 -7616 4 28.6164 10.8767 19.816 -47.8248 15.8998 30.722 -7617 6 39.4772 14.9486 19.552 50.4126 11.9025 42.2912 -7618 4 40.3976 15.2789 19.8627 -47.7598 -21.1435 -8.50237 -7619 4 39.4723 15.2512 18.6704 -12.4406 15.8155 -35.6919 -7620 6 32.8813 15.9868 22.8125 3.47488 17.0872 -31.9433 -7621 4 33.0166 16.4922 23.6113 -1.39335 7.20309 14.6349 -7622 4 32.7144 15.0846 23.0256 -4.37432 -22.045 19.0968 -7623 6 30.558 1.96704 21.5074 2.70654 -4.91402 -0.473851 -7624 4 30.6739 2.00523 22.4671 5.88049 3.20632 -1.97238 -7625 4 31.3728 1.59666 21.1136 -11.8747 6.17773 7.16567 -7626 6 0.976021 12.0022 3.31788 -2.33791 2.9975 -11.3542 -7627 4 1.23381 12.945 3.27167 -8.13702 -10.1344 5.41434 -7628 4 1.05317 11.6593 4.21576 7.83216 6.74936 8.77967 -7629 6 32.1417 30.4028 20.7928 -10.9162 7.90477 -12.8705 -7630 4 32.9583 30.6218 20.3315 4.32484 3.35409 -0.814586 -7631 4 31.4267 30.7883 20.2371 10.7836 -11.8724 10.7529 -7632 6 5.37233 35.5196 8.9984 1.65786 -0.655334 17.0686 -7633 4 5.15633 35.7733 8.10502 -8.52999 -6.98357 -10.434 -7634 4 4.86772 34.7263 9.2434 -1.9757 2.02155 -6.9424 -7635 6 49.9125 13.0387 32.1973 27.4626 15.6741 -16.8517 -7636 4 50.6053 12.9182 31.4733 -26.2683 -0.306922 26.3637 -7637 4 49.2504 12.3613 32.0764 -3.75185 -11.6573 -0.304044 -7638 6 4.31386 24.093 1.57868 7.45772 -24.8618 -14.5348 -7639 4 3.64218 24.7342 1.7864 -13.9986 8.43803 -2.25361 -7640 4 4.01488 23.4668 0.872394 2.3276 24.3041 16.4513 -7641 6 44.1644 38.1215 12.3455 -22.0907 -25.3739 20.9172 -7642 4 43.5152 37.5597 12.8481 16.1408 4.83783 -17.5332 -7643 4 43.8688 38.9961 12.5721 5.21907 21.319 -3.3764 -7644 6 44.6817 17.3326 22.8013 48.0619 -4.56356 -9.07637 -7645 4 45.2902 18.0584 23.1498 -22.5072 -22.7727 -5.21409 -7646 4 45.2932 16.6008 22.4593 -20.015 30.0459 19.1644 -7647 6 20.3678 11.7042 19.6638 18.1083 -41.9451 -24.672 -7648 4 19.8947 12.3606 20.1264 -14.0753 36.8205 14.9866 -7649 4 20.5011 12.0109 18.7433 -0.799123 0.72776 10.7716 -7650 6 4.45477 15.3976 36.1886 1.65809 1.26145 11.9226 -7651 4 5.09661 14.6681 36.098 -4.75494 5.61497 -10.92 -7652 4 3.56051 15.0123 36.2095 4.93474 0.57137 -3.51241 -7653 6 44.8032 39.5214 30.1736 10.2403 3.65831 -28.7798 -7654 4 44.6649 39.352 29.2044 0.893291 -3.4354 28.9244 -7655 4 44.1834 39.0261 30.7164 -9.9549 -0.503639 -4.51595 -7656 6 30.0776 3.52093 11.3186 -8.111 -9.63673 -5.93937 -7657 4 30.5797 4.33725 11.0789 -10.9699 -19.7375 -4.73534 -7658 4 29.9808 2.85663 10.5812 14.022 21.906 10.2093 -7659 6 25.6241 24.8658 16.1333 6.68449 -9.57605 -29.1286 -7660 4 26.5694 24.8046 15.8818 -8.72523 1.1772 17.1704 -7661 4 25.5267 25.1318 17.0381 12.8553 5.85519 26.3055 -7662 6 36.8177 29.8487 20.6561 -37.5479 -3.0004 33.0202 -7663 4 35.926 30.1959 20.4157 18.2985 -1.907 -0.407745 -7664 4 36.6716 29.3784 21.5423 12.7247 15.2026 -39.3319 -7665 6 52.2186 17.0658 38.3042 -7.89215 -38.4825 28.5148 -7666 4 51.4916 16.4675 38.6484 24.7832 21.5941 -14.95 -7667 4 51.8247 17.6139 37.6469 -10.8917 8.73986 -12.7264 -7668 6 3.82879 23.6249 29.8747 0.0111461 24.9347 -0.194649 -7669 4 4.57266 23.2964 29.3507 7.82142 7.55197 5.89536 -7670 4 4.12107 24.4472 30.3626 -2.93665 -31.334 -6.69289 -7671 6 6.37221 19.8955 41.0814 -10.7405 10.6187 0.232117 -7672 4 6.67124 19.2607 41.7286 9.67887 -12.4754 3.81392 -7673 4 6.49825 20.7419 41.4991 -1.14685 10.1205 10.9238 -7674 6 28.9128 38.9237 35.3305 22.4394 21.6131 25.3888 -7675 4 28.4594 38.2476 34.8641 -13.9867 -26.2755 -20.0992 -7676 4 29.711 38.4973 35.7105 -10.7836 3.83713 -8.57645 -7677 6 1.06675 30.3059 34.4729 25.4378 -4.31804 35.0042 -7678 4 0.780778 29.8064 33.7399 -5.76855 -22.7951 -38.2413 -7679 4 0.490797 31.0506 34.5199 -18.1513 16.5028 -0.872558 -7680 6 26.4359 22.0299 20.4363 32.8101 13.5123 0.44111 -7681 4 27.364 22.3315 20.3938 -13.8894 -16.1779 0.0777322 -7682 4 25.9647 22.8561 20.3336 -19.4369 -2.2953 -2.32927 -7683 6 3.94837 18.6341 22.6823 32.7056 -17.0211 23.8668 -7684 4 4.7768 18.6814 23.2391 -24.3494 -8.73456 -16.7413 -7685 4 3.72444 19.5457 22.6416 -13.4357 33.3979 -9.86072 -7686 6 6.89585 39.3162 26.9832 -46.5714 7.68979 7.72716 -7687 4 6.93923 40.0377 27.612 28.7888 3.33438 12.9127 -7688 4 5.92214 39.2413 27.0287 16.4173 -5.75108 -11.0421 -7689 6 43.9872 41.7521 26.5322 17.8857 -12.0416 -16.5154 -7690 4 43.9509 0.2718 27.3768 -8.40653 9.77536 19.5266 -7691 4 43.1315 41.809 26.1188 -22.0408 9.50446 -3.00799 -7692 6 31.7113 29.5746 16.987 -20.6637 1.93471 5.13032 -7693 4 31.02 28.863 17.0135 12.5534 15.6398 -7.64726 -7694 4 31.2508 30.4156 17.2234 10.2038 -24.3383 2.42367 -7695 6 46.2561 10.9612 15.5385 0.577538 -38.7584 22.3134 -7696 4 45.3251 10.7213 15.4484 -5.02058 7.03855 -0.171485 -7697 4 46.6569 10.0824 15.7727 -2.20865 28.2857 -11.3723 -7698 6 36.5827 15.0435 25.8168 31.2067 4.61936 9.12499 -7699 4 37.3875 15.5118 26.1911 -33.209 -18.98 -14.6655 -7700 4 36.1295 14.6889 26.5897 -4.0863 -6.05063 3.58839 -7701 6 47.2722 22.6647 6.13576 -8.17133 27.0247 -35.749 -7702 4 46.6204 23.3224 5.77393 14.8224 -22.4366 13.8178 -7703 4 46.9842 22.4705 7.01441 -4.98592 -2.25738 16.061 -7704 6 27.5378 39.6651 17.8024 -2.94112 10.9701 -10.3343 -7705 4 26.5953 39.7232 17.618 -8.53785 1.10642 -8.0722 -7706 4 27.5664 39.1005 18.5557 5.38052 -12.9364 18.2146 -7707 6 14.0357 27.9675 36.8848 11.7171 -39.9071 2.25396 -7708 4 13.4367 27.1833 36.8225 11.7441 28.4062 -4.63591 -7709 4 14.9372 27.5486 36.8957 -17.1932 18.8386 1.76957 -7710 6 33.7684 13.0304 13.8649 26.1794 -24.2655 -33.187 -7711 4 34.6252 12.938 13.363 -28.3858 22.7045 20.1179 -7712 4 33.4338 12.1329 13.7478 -6.61414 4.24237 14.4002 -7713 6 3.3826 17.477 1.97134 -12.4208 -32.1468 -36.6933 -7714 4 2.99872 16.7111 1.40376 19.9781 39.313 29.0042 -7715 4 3.44044 18.2025 1.33186 0.336883 0.1642 8.16047 -7716 6 27.5407 2.76347 36.4361 37.1152 10.6125 -5.75272 -7717 4 28.1274 2.95293 35.6781 -8.18971 -2.06925 12.0999 -7718 4 26.7696 2.41682 36.0063 -15.232 -6.73967 7.66134 -7719 6 21.3092 1.20818 18.7198 27.6808 -56.7894 17.4302 -7720 4 20.9088 2.03925 18.6129 -17.8717 42.912 1.2548 -7721 4 21.1846 0.863131 19.6413 -10.5106 12.8119 -18.3621 -7722 6 11.8887 16.6751 29.3062 -13.3787 -14.7829 9.57092 -7723 4 10.9992 16.5416 28.8882 19.0949 3.10928 11.6713 -7724 4 11.8781 16.1991 30.1864 -3.15773 18.3703 -25.9576 -7725 6 15.9606 29.4505 29.6321 19.1231 40.0535 19.8704 -7726 4 16.8787 29.2659 29.409 -1.79459 -0.812108 -5.15406 -7727 4 16.0576 30.3074 30.1528 -10.887 -31.0851 -11.0284 -7728 6 42.9296 7.03459 4.51333 33.3286 4.63812 8.33203 -7729 4 43.4321 7.52085 3.82302 -14.3213 -8.56549 9.51251 -7730 4 43.6462 6.74019 5.1384 -26.8219 -5.28882 -15.1101 -7731 6 46.4281 26.3352 18.5118 -29.5226 20.9834 -10.3716 -7732 4 46.6343 27.1839 18.9751 -0.829481 -30.2492 -9.82569 -7733 4 45.6684 26.5824 17.9287 20.9241 -8.5113 7.46212 -7734 6 26.8394 31.9326 30.1088 25.5924 -16.6135 -32.4851 -7735 4 27.2107 31.0232 29.8435 -20.3392 35.4128 12.4615 -7736 4 26.6802 32.4017 29.2373 1.48159 -21.8349 29.7067 -7737 6 19.4878 37.6142 31.2562 -14.4543 3.58951 24.8148 -7738 4 19.156 36.8698 30.7235 -3.28844 3.66685 11.8368 -7739 4 19.1019 37.6358 32.1884 8.87174 -10.6544 -29.6345 -7740 6 52.3726 32.7139 12.8078 14.0751 37.5782 -32.6023 -7741 4 51.9367 33.0602 12.0031 -5.44932 -19.1877 9.81768 -7742 4 53.2329 33.1776 12.7347 -13.6236 -17.9256 14.0183 -7743 6 6.74161 9.28353 24.0307 -13.1667 -36.0519 9.75632 -7744 4 6.38029 9.61276 23.1997 0.718458 -3.76261 -6.90188 -7745 4 6.16941 8.51095 24.2946 11.6474 19.2019 -8.42102 -7746 6 39.7455 39.5612 25.4988 -8.346 1.54154 -0.59194 -7747 4 39.7035 38.6168 25.2826 0.975023 6.38379 0.651723 -7748 4 38.8484 39.7767 25.8082 2.0142 -6.85885 -0.770105 -7749 6 24.0762 14.0053 21.1456 13.3165 -18.5501 -35.6859 -7750 4 23.5798 13.5675 21.8237 -9.9014 -1.44375 19.5869 -7751 4 24.3047 13.2647 20.5221 -3.72657 29.1491 15.9401 -7752 6 5.19759 41.7876 24.8616 10.5329 -30.3401 13.9713 -7753 4 5.96107 0.070496 25.4117 5.01198 -1.48177 -8.04364 -7754 4 4.80364 0.70791 24.6471 -6.87058 19.426 -10.6286 -7755 6 42.3635 20.8692 21.2747 32.7502 -34.6644 -10.1673 -7756 4 42.4242 20.4785 22.1458 -3.583 2.66194 10.2144 -7757 4 41.7418 21.5604 21.318 -29.6652 28.4695 2.24145 -7758 6 48.2477 15.3659 33.5923 1.80889 -1.28345 12.5443 -7759 4 48.6164 14.6993 32.9992 0.330488 0.612282 -4.05403 -7760 4 47.6342 15.9182 33.1009 -4.13716 0.340872 -13.8372 -7761 6 46.021 38.2915 16.5867 23.3569 13.4435 24.034 -7762 4 46.6714 37.7063 17.0526 -15.1447 15.3639 -15.4724 -7763 4 46.2171 39.2064 16.9307 -10.1858 -20.2136 -16.2853 -7764 6 4.64649 28.484 21.3661 -49.4423 -36.8464 -34.122 -7765 4 5.0061 28.857 22.1388 17.5694 9.2675 37.6073 -7766 4 4.11403 27.6656 21.6036 24.8595 24.6655 -3.1651 -7767 6 20.5601 15.1658 18.389 17.6685 -18.4833 12.4376 -7768 4 20.0269 15.9148 18.1339 -10.4277 9.01273 0.992097 -7769 4 20.1375 14.696 19.1318 -1.87864 11.9594 -2.12399 -7770 6 16.2536 13.648 17.4664 -31.6255 -3.12789 -19.3987 -7771 4 16.1444 14.6075 17.6118 2.65347 -13.1818 -8.15029 -7772 4 15.6032 13.3943 16.7283 22.0135 11.6863 31.5082 -7773 6 52.4969 30.9511 18.1582 10.5176 -22.8935 27.2955 -7774 4 52.1187 31.5845 17.5724 -17.5669 13.4893 -21.7562 -7775 4 51.7599 30.5669 18.6706 14.518 10.6779 -8.97027 -7776 6 24.417 1.73185 15.7818 -6.46311 -4.24469 33.4298 -7777 4 24.2563 1.19981 16.5985 3.98325 2.24538 -18.7421 -7778 4 24.1038 2.61269 16.0335 4.13298 0.832539 -9.96215 -7779 6 23.8696 5.09384 31.0808 18.8621 -40.8234 -26.8653 -7780 4 23.8491 5.89936 31.5593 0.144588 30.2314 14.3891 -7781 4 24.8063 4.82715 30.9043 -17.3015 12.7186 6.18451 -7782 6 29.664 30.9246 0.393748 19.8337 -4.81556 23.0674 -7783 4 30.503 30.586 0.018652 -21.3617 6.75777 -1.54054 -7784 4 29.144 31.3327 41.6109 -5.17979 -0.628515 -14.2195 -7785 6 32.8496 37.8945 22.5158 10.0753 4.77658 10.1953 -7786 4 33.692 38.178 22.1563 2.67507 -3.41774 -7.7275 -7787 4 32.953 38.1222 23.4459 -10.6691 2.21895 5.00606 -7788 6 16.4801 17.3789 33.7607 -9.23434 -4.14589 -23.771 -7789 4 15.9446 17.8653 33.093 7.5539 3.01496 23.5583 -7790 4 17.136 16.9338 33.2029 1.0053 3.7812 3.66748 -7791 6 9.22576 13.3955 27.544 21.8484 -6.91303 -4.28818 -7792 4 8.36976 13.4851 27.1157 -15.2219 0.444174 10.4645 -7793 4 9.14931 12.9772 28.4181 -9.36318 7.36421 3.71477 -7794 6 43.4776 7.7356 17.2334 -9.59035 3.82748 19.1182 -7795 4 43.4092 7.74545 18.2218 0.501649 1.62452 -33.0026 -7796 4 44.4173 7.85634 17.0579 0.99974 -1.57098 -4.99047 -7797 6 22.314 24.3423 23.1668 -12.6246 5.51695 -1.93377 -7798 4 22.7955 23.5193 23.2443 6.83464 -10.1031 3.26418 -7799 4 21.5276 24.1384 22.6266 3.35813 5.31764 3.82921 -7800 6 26.0086 32.9187 32.7195 -0.756619 6.65713 -1.20686 -7801 4 26.2515 32.7095 31.8047 -0.82286 -4.52018 -0.557583 -7802 4 25.2078 32.4163 32.9092 -2.81033 -0.378904 -0.617388 -7803 6 16.9305 19.0463 7.44765 14.0068 18.7364 -6.96389 -7804 4 16.3855 19.2981 8.21028 -2.47769 1.30563 -6.88861 -7805 4 17.0815 19.8512 6.87677 -9.59141 -23.4241 18.196 -7806 6 48.1118 14.458 27.5672 -1.70385 5.14823 10.3583 -7807 4 48.0423 15.1786 26.9235 1.90686 -4.78611 -1.19899 -7808 4 48.0875 14.8765 28.4507 4.89589 -0.740891 -11.823 -7809 6 52.3863 41.7399 11.1185 2.41988 14.2085 23.7397 -7810 4 52.3863 0.193993 10.2459 -4.45976 10.8931 -22.0542 -7811 4 52.6887 0.557857 11.7005 -5.56281 -10.4239 -7.84704 -7812 6 36.3311 6.93589 12.7094 -2.38398 9.53491 -1.97617 -7813 4 36.3789 7.90344 12.827 -2.48918 -10.7733 3.15906 -7814 4 37.2588 6.6822 12.6726 5.22435 -7.00461 -0.877062 -7815 6 8.24215 20.3216 16.6719 4.98767 -5.10439 -5.65687 -7816 4 8.08588 19.3952 16.4038 -4.3079 5.82994 10.8424 -7817 4 9.2046 20.4438 16.7199 -1.30961 -3.63404 -4.19262 -7818 6 28.7954 40.3113 12.828 -13.6179 6.23593 21.4452 -7819 4 29.5192 40.3706 12.2287 20.8327 -7.3113 -16.8089 -7820 4 28.5554 39.3777 12.9053 -3.26344 4.60902 -2.65931 -7821 6 18.1473 11.8343 16.9395 -0.80483 -16.2761 12.6256 -7822 4 17.6848 12.6388 17.2294 4.62203 -2.59462 -3.9508 -7823 4 19.0947 11.9922 16.9221 7.13726 16.095 1.27241 -7824 6 30.8869 17.4142 21.504 -52.7305 12.2285 -31.3088 -7825 4 30.1482 16.8222 21.1884 27.1221 10.2955 22.0665 -7826 4 31.6253 16.8731 21.7262 19.9221 -18.6281 13.9623 -7827 6 34.8012 19.4194 37.9626 16.1869 22.0253 -15.6613 -7828 4 34.8979 20.1386 37.2822 -2.41662 -18.1877 20.3873 -7829 4 34.2105 18.7604 37.6043 -6.15487 -8.04615 -10.7113 -7830 6 35.8208 16.8923 29.2032 22.3367 20.7443 33.8648 -7831 4 36.613 16.5252 29.6466 -9.20578 0.119567 -6.22754 -7832 4 35.5382 16.2441 28.5922 -11.4717 -30.451 -21.7041 -7833 6 3.04279 32.2854 6.33929 -26.9238 12.3825 -4.69033 -7834 4 2.12647 32.146 6.0594 1.42689 6.59766 6.64942 -7835 4 3.42261 31.4611 6.08203 25.9982 -20.506 -0.598367 -7836 6 26.7966 41.6596 10.1464 32.6739 -10.8326 9.81865 -7837 4 27.6955 41.4226 9.79016 -25.5431 4.71255 4.81996 -7838 4 26.9918 0.01593 11.0584 -5.4334 2.64263 -3.14356 -7839 6 52.266 24.562 24.8685 -9.42886 0.421982 -6.72882 -7840 4 51.3046 24.7615 24.9057 17.7877 -5.82089 5.23086 -7841 4 52.6568 24.8699 25.6923 -4.67896 5.24225 9.60646 -7842 6 22.6938 22.6511 33.5751 -3.71591 7.58927 38.5179 -7843 4 23.2073 23.1628 34.2375 -1.81825 -3.74423 -24.5931 -7844 4 21.9227 22.4274 34.1227 -1.3969 -6.37714 -14.1968 -7845 6 10.6508 14.2453 33.0462 38.3111 -19.1724 1.31243 -7846 4 10.5904 14.9583 32.4175 -11.7628 10.624 -9.61146 -7847 4 9.79743 14.0525 33.3881 -28.4056 0.15536 2.16046 -7848 6 21.8963 10.8464 11.5207 26.0054 2.65771 10.2946 -7849 4 22.8204 10.615 11.7238 1.04479 5.32162 -7.74354 -7850 4 21.5123 10.8483 12.397 -14.7134 -4.5627 10.8449 -7851 6 38.3602 6.02493 25.8481 -1.65407 -6.16467 0.326828 -7852 4 38.011 6.16356 26.7557 4.19059 11.4538 -13.8011 -7853 4 38.4332 6.8537 25.3449 -2.0709 2.94932 12.5244 -7854 6 30.9335 26.6426 38.5759 12.2579 -6.52521 -50.146 -7855 4 30.9725 26.4832 39.4983 -1.12433 -12.3748 34.5417 -7856 4 31.1634 25.7976 38.1184 -10.2303 12.0451 18.6771 -7857 6 30.1758 14.6176 35.4883 -28.0954 45.5198 -22.6945 -7858 4 30.377 15.4621 34.9933 16.3957 -28.3235 8.82257 -7859 4 29.2055 14.6893 35.4544 11.1506 -16.8188 10.9927 -7860 6 12.5393 37.2199 16.9523 -39.8589 -5.36999 -7.27655 -7861 4 12.8749 37.9509 17.4338 22.3846 22.4284 20.6781 -7862 4 13.1653 36.5135 16.9845 23.2041 -13.3789 -0.375674 -7863 6 27.4265 21.5607 37.7225 20.8747 -12.9562 -0.181201 -7864 4 26.9326 21.725 36.9211 -12.0211 3.79264 -7.84561 -7865 4 27.0206 21.994 38.4656 -12.5008 8.35973 2.85409 -7866 6 29.6119 18.3909 12.6766 5.02953 -16.5769 27.1188 -7867 4 29.5217 18.1084 13.6179 -1.01954 6.11509 -19.9302 -7868 4 28.7057 18.4542 12.3734 -9.03627 4.70036 -1.08008 -7869 6 2.35849 15.6559 0.172343 -13.1317 26.5324 40.4931 -7870 4 1.57628 15.538 41.5798 -33.9312 2.46749 -10.4392 -7871 4 2.94928 15.1153 41.6306 46.9044 -35.3027 -23.6199 -7872 6 17.8239 25.728 4.21905 -37.6117 -8.49993 -31.7596 -7873 4 16.8718 25.6243 3.8952 33.4499 1.9374 22.526 -7874 4 18.2969 25.7387 3.3671 7.88894 5.9968 18.5236 -7875 6 41.8048 11.1855 20.2736 -2.74436 -4.31591 -6.39865 -7876 4 42.499 11.3266 19.6063 -2.31748 -7.213 6.47037 -7877 4 40.9812 11.3277 19.7997 -4.16553 7.78699 0.129723 -7878 6 38.0436 18.3822 24.0291 -8.03771 -8.75406 0.916934 -7879 4 38.3881 19.1147 24.5363 7.93091 8.32946 7.65245 -7880 4 37.8775 18.7197 23.1534 1.15748 3.59885 -9.88254 -7881 6 4.13949 13.9245 33.751 32.8429 -54.5446 -5.73928 -7882 4 3.27676 13.674 34.0388 -19.3763 3.63281 4.9893 -7883 4 4.61955 13.0097 33.6871 -20.752 50.0513 -2.76975 -7884 6 19.1955 19.1942 26.4999 -2.68794 -13.6734 16.0889 -7885 4 19.5301 20.0447 26.2113 2.49975 9.05121 -5.4902 -7886 4 18.8802 18.7176 25.7363 0.91839 -0.338605 -10.966 -7887 6 22.4654 26.212 25.3377 -43.9819 -31.3945 15.8492 -7888 4 22.341 25.462 24.7348 6.987 2.92742 -4.90062 -7889 4 23.2684 26.6111 25.1223 47.0594 15.091 -19.0516 -7890 6 48.8212 32.07 32.5598 -32.6217 13.0764 9.49579 -7891 4 48.8519 31.1339 32.3903 9.77015 -16.5586 -2.94571 -7892 4 49.6142 32.4858 32.2593 19.8009 3.1546 -7.06015 -7893 6 25.2092 18.0177 27.0119 4.84672 -18.7822 -3.15467 -7894 4 24.5216 17.4674 27.4199 2.41306 12.0417 3.55819 -7895 4 25.6695 17.4202 26.3966 -2.25094 9.61905 1.21472 -7896 6 1.75029 41.5558 24.9373 10.8929 -9.66126 -16.5331 -7897 4 1.94143 40.8029 24.3062 -11.1729 27.8661 22.017 -7898 4 1.33214 0.330238 24.3814 7.15774 -16.2959 10.6574 -7899 6 18.6827 11.7655 10.8523 -12.8723 -21.6642 16.1997 -7900 4 19.5636 11.9042 10.4948 -5.12175 -0.337419 -4.96303 -7901 4 18.6779 10.8452 11.2231 -2.76434 23.9208 -10.2934 -7902 6 45.6216 16.5622 4.85345 35.2391 7.72621 -8.96994 -7903 4 46.5826 16.2921 4.84248 -29.2944 1.01327 2.32041 -7904 4 45.6571 17.5026 4.56372 -8.00263 -16.2723 6.75488 -7905 6 40.6693 36.3938 24.0175 15.8353 8.34465 -33.37 -7906 4 40.8833 36.7626 23.1096 -14.2319 -6.57786 31.0793 -7907 4 40.765 35.4388 23.9669 -2.25062 -4.28397 3.06966 -7908 6 32.2103 36.323 4.961 11.3673 -15.0032 -27.5021 -7909 4 31.6022 36.0041 4.27996 -13.8963 14.3234 5.17466 -7910 4 32.9864 35.7931 4.73143 4.05858 7.46319 17.1387 -7911 6 1.60869 14.6755 10.8061 -10.0389 6.06769 39.8197 -7912 4 2.33356 15.3221 10.9109 -7.21973 -7.23845 -0.707439 -7913 4 1.19104 14.6475 11.7231 10.7485 2.93157 -30.114 -7914 6 35.0001 14.2727 28.079 63.2852 10.3217 34.449 -7915 4 34.8812 14.1453 29.0533 -4.19424 -2.10072 -23.3494 -7916 4 34.1798 14.2655 27.6589 -51.5469 -5.32036 -14.2309 -7917 6 54.7125 6.11605 21.8555 -14.0361 -8.25377 2.86163 -7918 4 53.7845 6.02557 22.1597 12.8111 1.82594 -4.22103 -7919 4 0.03027 6.89073 22.319 4.64766 10.0402 5.34703 -7920 6 31.7713 16.925 27.3783 -6.86907 -7.88471 17.2493 -7921 4 30.8352 17.1376 27.29 -7.38275 1.84485 -8.02972 -7922 4 32.1916 17.1776 26.567 8.49209 11.7792 -21.4891 -7923 6 14.465 28.0197 11.093 -4.59026 -39.5121 13.6529 -7924 4 14.1257 28.8224 11.4501 -8.46011 24.0779 0.0563038 -7925 4 14.7692 28.1802 10.1981 4.52198 5.50754 -5.24146 -7926 6 35.6475 19.4845 18.3155 9.57103 -1.809 -3.39748 -7927 4 36.1727 19.3545 19.1113 -4.74674 6.51425 2.74698 -7928 4 35.0476 18.7267 18.3208 -0.78661 10.9943 -3.1182 -7929 6 0.909574 12.7326 15.4512 -4.00403 -44.3255 -0.361194 -7930 4 0.713888 11.7498 15.2844 2.79491 38.2978 9.54583 -7931 4 1.42535 12.7402 16.2831 -6.10996 -1.10113 -5.97882 -7932 6 52.7151 14.8297 20.9852 -8.18072 -78.4028 12.8764 -7933 4 52.2089 13.9625 20.7908 19.9141 35.1606 18.4317 -7934 4 52.3599 15.4219 20.3591 -8.09633 28.1752 -16.3986 -7935 6 7.5074 6.79303 13.6094 20.1749 -33.1825 -2.20484 -7936 4 7.51894 7.72815 13.8132 13.5555 7.5777 -3.02343 -7937 4 8.44355 6.42469 13.5879 -32.5694 21.0012 0.325521 -7938 6 12.8707 29.146 30.9458 -23.5578 15.3335 -40.981 -7939 4 12.9428 28.445 30.3111 -4.06483 -0.044806 -18.3112 -7940 4 13.2276 28.7127 31.6654 25.7046 -17.9249 62.7325 -7941 6 8.91318 29.991 35.6703 -0.0610651 3.14803 31.5119 -7942 4 8.887 30.0597 36.6571 13.1627 -14.4278 -23.4692 -7943 4 8.81345 30.9051 35.4106 0.983205 7.41015 -17.1111 -7944 6 29.2436 7.20633 5.57892 -54.0378 33.243 -15.4453 -7945 4 29.9077 6.6209 5.82325 37.3203 -38.0996 12.3519 -7946 4 28.4255 6.92245 6.05186 24.5111 10.6259 -6.90283 -7947 6 25.8948 9.2579 3.86177 -16.7921 -19.1399 -16.9328 -7948 4 26.6486 8.78935 3.46547 3.6066 2.83982 9.7025 -7949 4 25.146 8.75694 3.47524 9.6908 8.1243 10.3781 -7950 6 46.1591 19.5353 23.8511 81.1089 -3.44953 5.31324 -7951 4 47.0572 19.4192 24.3423 -46.5837 0.334518 -9.80273 -7952 4 46.5432 19.8542 23.0066 -21.4105 0.836057 1.37554 -7953 6 18.5926 35.3225 28.784 52.2521 -24.0621 1.05868 -7954 4 18.6271 36.1437 28.292 -9.91963 10.3291 -8.20284 -7955 4 19.5499 34.9756 28.7398 -42.866 14.0686 4.10052 -7956 6 27.9863 22.6413 32.202 21.6529 -11.7193 -18.2399 -7957 4 28.0891 22.9783 31.3009 1.03266 3.02954 6.56078 -7958 4 27.1414 22.9613 32.5068 -4.28354 -0.549074 4.96673 -7959 6 25.9903 18.4326 22.6797 -22.9747 -15.6034 11.3844 -7960 4 26.7869 18.8273 22.3692 24.9379 13.7229 -5.91644 -7961 4 25.7208 18.921 23.4832 11.724 -6.94511 -8.75168 -7962 6 31.1697 23.092 29.1693 -11.9745 -15.1316 21.2053 -7963 4 31.2077 22.141 28.9533 -3.34012 7.58841 -3.35467 -7964 4 31.7416 23.575 28.5808 9.8436 3.86516 -11.5721 -7965 6 36.6303 4.93142 0.48008 48.3 12.3871 -22.3067 -7966 4 36.6637 5.82298 0.895967 -3.77214 -15.5899 -6.86281 -7967 4 37.4556 4.91994 41.7793 -42.6939 0.501904 23.801 -7968 6 36.4828 20.995 10.0445 1.4409 16.9025 7.88029 -7969 4 36.442 20.1354 9.60774 -3.67605 2.90774 1.0232 -7970 4 35.8889 20.9899 10.8082 0.675338 -5.55749 -3.21659 -7971 6 50.6068 25.1826 18.3885 -34.0155 8.99756 4.28297 -7972 4 49.9165 24.7513 17.8483 3.12051 4.84127 10.9758 -7973 4 51.4426 24.9479 18.0312 23.0155 -7.64449 -5.94589 -7974 6 50.1857 39.6546 12.4249 -35.8487 -4.75972 18.1961 -7975 4 49.7435 38.8097 12.6589 9.38526 12.3917 -5.89531 -7976 4 51.0761 39.4561 12.2056 25.3285 -5.23538 -8.69122 -7977 6 30.5392 12.4112 4.81308 -24.6918 -8.37115 23.8709 -7978 4 30.0105 11.5821 4.90198 12.5687 16.0288 7.14 -7979 4 30.9611 12.2897 3.99028 20.9425 -4.88336 -30.4106 -7980 6 28.9507 15.4785 21.8764 2.88494 -37.77 16.9414 -7981 4 29.2026 14.5932 22.3105 -13.0637 39.016 -13.1967 -7982 4 28.2142 15.8194 22.4189 7.40001 -5.36107 -10.8423 -7983 6 14.0621 9.56364 16.9937 6.86557 -12.9325 3.68967 -7984 4 14.7638 8.91135 17.1437 -0.397896 3.39204 -3.97785 -7985 4 14.5001 10.412 17.0773 -1.84745 7.98018 -3.95086 -7986 6 4.48418 30.1793 11.8502 16.4679 -16.8356 33.0547 -7987 4 4.88144 29.8061 12.6848 -7.18701 8.62616 -23.9784 -7988 4 3.54784 30.2411 12.0492 -7.30801 4.11375 -9.31782 -7989 6 40.8925 8.06286 23.6531 -5.33465 -0.617655 -7.49645 -7990 4 40.8929 8.28602 22.6923 5.67883 -10.477 13.1878 -7991 4 40.7177 7.10184 23.7416 4.86142 9.55736 -10.8624 -7992 6 53.7474 35.0502 16.7091 9.64852 13.8526 -34.5004 -7993 4 53.4511 35.8404 17.1588 -1.68768 2.98716 11.3576 -7994 4 54.0332 35.3898 15.821 -5.01984 -16.258 24.672 -7995 6 53.7089 10.1864 20.3635 2.29909 -3.91508 11.8946 -7996 4 53.865 9.95358 19.435 -6.30341 10.2468 0.803923 -7997 4 53.074 10.9174 20.4153 4.1525 1.61451 -13.3956 -7998 6 4.58325 27.0727 7.79253 38.2121 26.3993 -10.0836 -7999 4 5.27724 26.393 7.80253 -10.2172 -9.80276 1.23658 -8000 4 3.71677 26.7514 7.92113 -24.69 -25.9094 6.50141 -8001 6 50.5074 22.5408 22.1421 -8.69376 -16.3879 19.9073 -8002 4 50.2488 23.2402 22.7623 5.11604 2.17524 -13.9015 -8003 4 50.7961 22.8564 21.2903 3.5618 14.8025 -7.32432 -8004 6 7.04732 27.2027 21.6256 -40.8926 -21.8944 23.9514 -8005 4 6.7035 26.7027 22.422 28.3929 12.8045 -18.4773 -8006 4 6.19014 27.4064 21.2095 22.0893 5.82121 -6.88916 -8007 6 23.8331 35.0488 16.5891 16.32 14.4309 46.4508 -8008 4 24.6955 34.7392 16.9507 -15.4311 10.68 -10.0146 -8009 4 23.6772 34.608 15.7848 -0.180345 -20.5093 -35.2233 -8010 6 5.99568 23.9111 3.91414 -16.1284 -13.3557 2.33299 -8011 4 5.47632 24.0272 3.08057 3.14343 -7.41418 20.837 -8012 4 5.41258 23.5631 4.6401 5.53308 9.77645 -18.8553 -8013 6 38.7285 25.0725 19.1284 6.5843 12.292 11.4002 -8014 4 38.8305 24.3279 18.5317 -0.433768 -14.0645 -4.65001 -8015 4 38.9527 24.8378 20.0476 4.74577 -1.1864 -10.184 -8016 6 12.9754 18.2903 10.6176 0.588158 -4.74371 -11.7219 -8017 4 12.1189 18.2831 10.1754 -4.50324 1.27903 -1.36841 -8018 4 12.8026 18.5801 11.5112 2.24696 5.46905 14.7352 -8019 6 38.0467 41.2366 21.1082 -14.4892 -16.6352 -5.66336 -8020 4 37.1721 40.8226 21.1941 10.2151 -2.13153 3.70269 -8021 4 37.8745 0.133442 20.6393 0.730193 23.6843 -6.95691 -8022 6 6.9767 22.8602 17.8447 -15.6268 -18.8158 0.81989 -8023 4 7.5707 23.5707 17.6602 21.732 18.7089 -7.75629 -8024 4 7.31556 22.0497 17.428 2.05587 4.83625 4.35773 -8025 6 24.1095 19.3932 12.3316 12.1602 -2.11517 -13.1018 -8026 4 23.8745 19.734 13.1953 2.64822 12.0925 0.881714 -8027 4 23.8476 18.4865 12.3899 -10.6841 -23.2361 -5.46211 -8028 6 44.2232 28.4408 4.82746 -1.7669 2.66578 -25.5607 -8029 4 44.2803 28.1144 3.91045 1.22274 -3.80694 10.7546 -8030 4 44.1446 29.3994 4.68927 4.81937 -0.158515 8.55 -8031 6 23.3113 8.29915 21.4219 -9.51684 27.1403 7.66167 -8032 4 22.936 9.22921 21.4746 15.7805 -27.4461 5.90598 -8033 4 23.1012 8.0569 20.5135 3.89809 -6.65443 -0.402871 -8034 6 14.3464 2.18773 18.5362 -23.516 16.4481 4.67993 -8035 4 14.2678 1.24418 18.6898 10.1474 -10.2606 4.48578 -8036 4 15.2445 2.40605 18.3047 18.9771 -8.71598 -6.68368 -8037 6 28.0424 31.9381 34.1184 1.44373 -10.4149 10.0158 -8038 4 28.467 32.321 34.8914 3.92062 5.65333 3.09761 -8039 4 27.2701 32.5111 33.9835 5.51879 -6.95928 -12.9635 -8040 6 53.345 24.6925 18.2818 -10.4918 -25.9433 -31.7967 -8041 4 53.4866 24.6975 17.3285 -0.882305 -10.6531 -2.1422 -8042 4 53.7306 25.5021 18.5264 15.118 39.739 24.3772 -8043 6 36.8049 28.4285 22.9464 16.1639 5.31016 -1.79263 -8044 4 36.683 28.9472 23.7552 -13.3671 -7.69746 -0.238436 -8045 4 36.1639 27.7179 22.9267 -11.0056 -9.60672 10.1241 -8046 6 21.894 30.586 27.4834 -30.837 -7.47848 12.2714 -8047 4 22.1658 31.0121 28.3029 9.93408 7.2142 -4.82479 -8048 4 22.5499 30.6966 26.8178 23.3081 1.01511 -13.2982 -8049 6 10.2866 3.2829 27.2371 9.19947 -3.548 -7.92128 -8050 4 10.1566 2.73648 28.0281 -11.5907 7.20828 -5.58516 -8051 4 9.50383 3.79492 26.9844 -8.05462 -4.00143 11.7964 -8052 6 37.7145 25.01 29.7057 15.6828 -51.4836 -24.4954 -8053 4 38.34 24.5625 29.0621 -16.831 21.3675 19.2093 -8054 4 37.2613 24.2159 30.07 -2.41186 22.6264 5.87672 -8055 6 9.13271 24.4444 14.4751 26.0421 8.18538 46.692 -8056 4 9.10912 24.9781 13.7161 -5.31341 21.9098 -32.4591 -8057 4 8.68548 23.6494 14.2981 -19.3974 -37.2941 -14.6224 -8058 6 52.771 31.4727 7.38558 20.6973 -2.13415 1.08713 -8059 4 52.3061 32.183 6.93204 -2.34942 2.78723 -4.55897 -8060 4 52.1263 30.9997 7.89938 -16.8139 -9.70652 3.3966 -8061 6 21.3286 5.45224 36.4983 22.333 -40.4406 3.83692 -8062 4 20.7026 5.40277 37.2139 -7.55906 11.9598 8.05023 -8063 4 21.8475 4.61683 36.6516 -9.65069 29.8227 -15.0031 -8064 6 25.1743 37.2092 4.31919 7.23092 6.80805 -6.24923 -8065 4 25.4754 36.7175 3.5165 -8.68629 0.834167 19.7743 -8066 4 24.8491 36.6197 5.01948 2.53349 -5.19005 -7.77823 -8067 6 34.0165 17.4759 18.2358 -58.4306 -31.0723 45.6386 -8068 4 34.1944 16.9598 19.0779 8.50138 15.1756 -22.5601 -8069 4 33.0528 17.7413 18.4058 39.5305 3.9888 -12.396 -8070 6 37.9578 37.5059 25.2944 -35.6234 -15.4362 -10.7836 -8071 4 36.9622 37.6721 25.197 38.0574 -5.35834 -1.14338 -8072 4 38.1643 36.7565 24.689 -7.79603 13.8086 8.25116 -8073 6 5.07735 4.86484 15.8417 42.9381 3.72816 7.10952 -8074 4 5.88838 4.293 15.9163 -33.8081 0.492332 -6.16483 -8075 4 5.50277 5.71956 15.9997 -16.006 -0.473971 1.61617 -8076 6 14.1507 7.19336 7.76886 38.052 -10.4208 -22.4486 -8077 4 13.5129 7.55624 8.34295 -29.9694 15.266 25.1048 -8078 4 13.7195 6.96448 6.9333 -0.98027 3.69224 9.82406 -8079 6 24.98 10.8641 38.0829 22.9212 14.7137 56.6455 -8080 4 25.3157 11.7906 38.09 -5.76353 -21.6486 -14.5596 -8081 4 24.5861 10.6473 37.2742 -21.4949 -6.61803 -48.2716 -8082 6 35.683 7.97762 22.8121 -8.7657 -2.24292 -6.28447 -8083 4 36.2591 8.71308 23.0369 7.49089 3.45465 4.10549 -8084 4 35.4159 8.13228 21.894 -1.16553 2.61323 2.89561 -8085 6 24.8067 29.1485 22.4175 -2.13284 -11.1741 5.39142 -8086 4 24.8847 28.3567 22.9764 5.78872 7.02228 0.265808 -8087 4 23.868 29.1687 22.2304 -8.38579 3.51829 -7.32943 -8088 6 38.496 31.6463 38.4547 5.18571 -7.52333 -11.192 -8089 4 38.5561 32.3892 37.8222 0.442926 -5.96945 11.3455 -8090 4 38.4779 31.9675 39.3579 -6.04594 15.0172 8.52038 -8091 6 7.23911 33.2316 15.4021 21.919 9.41665 12.382 -8092 4 8.12833 33.2899 15.8377 -30.0201 5.59214 -9.80336 -8093 4 7.41373 32.5516 14.7298 -12.8129 5.82399 11.4308 -8094 6 43.353 23.6104 1.44592 7.44142 11.305 12.851 -8095 4 43.1845 24.4377 0.974361 -3.6145 -11.1369 -5.61195 -8096 4 44.1543 23.8467 1.95013 -11.1925 -12.9992 -13.6036 -8097 6 3.53991 32.9016 14.8697 -2.39625 2.76445 6.29056 -8098 4 3.69073 33.2429 13.9877 -3.53656 0.018747 -12.9915 -8099 4 3.78624 33.6349 15.4383 2.83762 5.11564 5.16825 -8100 6 25.3096 21.77 8.26163 -6.66296 0.990367 -4.9072 -8101 4 26.025 21.1206 8.24337 -4.14835 5.1806 10.2199 -8102 4 24.7855 21.68 9.08833 13.2195 -2.77387 -11.0894 -8103 6 43.8224 15.3683 17.7688 -17.5044 -13.9077 -11.4765 -8104 4 43.5422 15.0425 16.8907 -4.65964 7.2866 4.53357 -8105 4 44.7684 15.2434 17.7192 12.2011 1.97977 1.51727 -8106 6 15.7838 16.2525 16.6573 54.0838 12.7989 52.3812 -8107 4 16.4697 16.8261 16.2793 -6.54184 -0.771336 -3.5329 -8108 4 15.1467 16.1661 16.0105 -48.6612 -2.23154 -48.9531 -8109 6 31.9022 12.8519 11.5241 2.75902 49.2592 5.12049 -8110 4 32.4395 13.2725 12.2474 -7.6131 -20.2803 -12.0836 -8111 4 31.5562 13.6461 11.0457 0.0384164 -26.7823 6.27126 -8112 6 18.2248 5.33623 10.1812 -15.488 18.8418 -23.6702 -8113 4 17.7687 5.75894 9.42369 15.7694 -11.8332 4.62439 -8114 4 17.5271 5.29555 10.8288 -1.36455 -9.23689 12.3446 -8115 6 23.0917 39.0779 10.9282 -11.4905 7.21092 -0.352408 -8116 4 23.963 38.6888 10.8472 1.7552 7.95734 1.65941 -8117 4 23.1114 39.9529 10.5005 0.666922 -10.0515 1.633 -8118 6 46.8677 33.7562 8.76248 1.03354 -2.05441 8.38343 -8119 4 46.5037 34.5328 8.27588 2.5022 -8.853 20.9954 -8120 4 47.1475 33.9422 9.6931 -6.44786 13.1686 -22.3696 -8121 6 31.243 39.9317 20.2224 2.33635 -7.70313 -8.05101 -8122 4 30.8704 39.2996 19.5871 0.699046 7.37293 6.91414 -8123 4 32.2017 39.8574 20.0757 -3.27099 6.09826 0.0696837 -8124 6 15.889 33.0919 19.7864 33.8788 -7.40125 -13.3883 -8125 4 16.1628 33.8221 19.1895 -10.4151 -15.5823 0.760964 -8126 4 16.5176 32.3427 19.5839 -16.9866 18.4919 10.6578 -8127 6 32.5555 39.9164 2.66523 30.0039 -10.6491 -2.95451 -8128 4 33.3508 39.5896 3.12591 -10.8726 3.49711 -8.16538 -8129 4 32.1027 40.3655 3.36837 -16.5932 8.39248 6.84073 -8130 6 50.6959 12.1983 3.90519 17.0412 -18.9771 -24.2847 -8131 4 51.4658 12.4814 3.40053 -2.43524 -2.94964 -4.56419 -8132 4 50.632 12.8314 4.58319 -9.04718 30.5099 32.8795 -8133 6 44.7022 2.76366 12.1205 -8.84849 12.6495 8.41904 -8134 4 44.8494 1.8734 11.8267 15.0216 -15.1797 -4.64519 -8135 4 44.7278 2.73137 13.1008 3.87902 2.35132 -20.2006 -8136 6 11.5141 11.9335 31.6448 -3.41939 3.48047 19.9552 -8137 4 11.2577 12.7405 32.1375 2.53248 -5.05318 0.0588515 -8138 4 11.4496 11.2091 32.2982 6.40928 8.91696 -7.15415 -8139 6 4.75269 10.0418 10.4949 -1.19321 15.9867 3.21309 -8140 4 5.0001 10.2283 11.4058 3.15466 -0.54389 -0.234941 -8141 4 4.46559 10.9018 10.1184 3.18705 -14.0527 1.96128 -8142 6 17.0994 25.0099 20.58 37.5195 36.994 -31.4742 -8143 4 16.2483 24.8536 20.9144 -42.3557 -15.7488 8.6923 -8144 4 16.9647 25.6792 19.8535 4.26961 -24.361 15.5384 -8145 6 48.1092 4.75471 14.8037 19.9531 12.9172 -19.4869 -8146 4 47.21 5.0173 14.8371 -33.3483 -4.43172 15.4156 -8147 4 48.388 5.38041 14.11 12.4129 -13.382 8.75366 -8148 6 18.8523 3.11742 3.41631 -21.2483 -3.07087 -4.7476 -8149 4 18.4665 2.24821 3.59937 1.50537 0.955968 2.27262 -8150 4 19.7704 2.98892 3.60058 26.8928 -3.50499 2.30699 -8151 6 35.4247 26.4577 29.0527 -22.8013 -8.66021 5.68805 -8152 4 35.5248 27.2067 28.475 -2.85698 13.778 -9.76065 -8153 4 36.2768 26.0489 29.0602 21.3259 -10.4415 3.203 -8154 6 32.3896 31.2185 12.8503 57.1958 12.7231 -6.23232 -8155 4 31.5925 31.2509 13.3022 -48.7441 2.01486 27.8379 -8156 4 32.2029 30.8426 12.0127 -5.8383 -14.614 -31.3947 -8157 6 33.0076 28.3366 37.5983 -27.3824 -5.67666 30.0102 -8158 4 32.1052 27.9852 37.8568 28.4022 2.55731 -9.07316 -8159 4 33.3988 28.5694 38.4733 -3.969 -4.9759 -22.0899 -8160 6 45.5072 24.7908 10.3169 -45.8214 60.3209 -7.47747 -8161 4 44.9002 25.317 9.70444 28.5781 -13.9385 29.3176 -8162 4 45.5876 23.9971 9.85482 14.9117 -49.3191 -19.3714 -8163 6 14.779 31.7044 3.16918 -45.5594 -6.97168 29.5477 -8164 4 14.0337 32.2859 2.90387 21.9125 -3.3602 -3.07131 -8165 4 14.4311 31.26 3.996 20.2164 14.1486 -26.6391 -8166 6 31.9242 7.68885 4.30286 23.54 -20.9123 31.4536 -8167 4 31.4705 6.84633 4.17995 2.0164 -2.82895 4.59018 -8168 4 31.5931 8.24323 3.64247 -18.259 33.7262 -37.7068 -8169 6 42.5699 17.3136 32.1968 24.1944 7.3606 3.32713 -8170 4 41.6254 17.2329 32.2603 -19.9776 4.79877 -7.53323 -8171 4 42.7917 18.2007 31.8224 -10.4585 -19.5065 0.0265862 -8172 6 13.8071 23.1746 23.5515 16.4347 -15.6283 -2.15259 -8173 4 13.5183 23.7639 24.245 0.233797 9.11225 10.6616 -8174 4 14.6093 22.7029 23.9066 -20.7684 16.5326 -5.05411 -8175 6 10.7126 7.09833 3.97095 14.1471 -33.6721 -68.9477 -8176 4 10.4245 6.93934 4.82914 -14.4566 -0.97954 55.1879 -8177 4 10.4869 6.2311 3.50145 10.3151 35.4271 10.8748 -8178 6 28.7967 8.6797 17.9015 -30.1103 -2.72244 -33.0478 -8179 4 29.5795 8.35746 17.4579 9.90558 -6.78874 -8.85398 -8180 4 28.1705 8.90161 17.1378 19.1156 -3.64084 26.8114 -8181 6 19.4515 29.3423 26.6295 -39.4767 12.5835 42.7579 -8182 4 19.0038 29.6555 27.482 17.5864 -10.0531 -35.2193 -8183 4 20.2946 29.7741 26.6551 17.8114 4.03003 1.9258 -8184 6 40.6571 40.9865 14.5722 30.7749 0.116883 17.4953 -8185 4 40.9453 41.7159 14.038 -4.90719 13.3855 -18.4876 -8186 4 41.4974 40.7167 14.9881 -11.2006 -4.47055 2.16552 -8187 6 46.2595 14.0857 31.7293 11.6035 -9.35965 4.24636 -8188 4 46.4659 13.1386 31.6985 -1.25294 5.8657 1.71226 -8189 4 45.5092 14.1916 31.1613 -13.5258 4.10617 -10.238 -8190 6 36.7111 36.3198 8.38634 20.5175 24.5507 44.7988 -8191 4 36.5848 37.248 8.66174 -25.6048 -20.3538 -28.8485 -8192 4 37.4262 36.1922 9.03978 -4.76011 -28.7723 -18.9481 -8193 6 30.7791 32.4382 38.0814 8.60258 1.74334 21.9396 -8194 4 31.3949 31.9394 37.5795 9.21482 -20.9838 -26.5205 -8195 4 31.4122 32.9586 38.5821 -11.3785 16.1645 3.6603 -8196 6 47.8794 8.8384 10.1746 26.299 41.1069 27.7005 -8197 4 47.2075 9.11907 9.56312 -13.0744 -2.84885 -16.672 -8198 4 48.1152 7.93695 10.1106 -1.40956 -33.8723 -12.987 -8199 6 24.4191 17.0005 30.9872 -11.3759 2.04439 -13.9008 -8200 4 23.6647 16.9339 30.3566 16.9629 0.0568796 9.7226 -8201 4 24.0218 17.1528 31.8579 2.94571 -1.21426 -7.57694 -8202 6 40.5018 5.09847 4.47991 -26.6992 -20.3188 -5.14046 -8203 4 41.28 5.65048 4.47318 14.3705 11.228 -11.5737 -8204 4 40.0798 5.05838 3.58104 19.0568 4.03597 15.916 -8205 6 52.5742 28.0973 6.9077 -25.4379 -29.0344 16.6943 -8206 4 52.3933 28.6001 6.11132 1.2128 1.19853 -1.81518 -8207 4 51.7383 27.5823 7.10916 28.4347 22.908 -9.38917 -8208 6 36.064 32.3866 23.6124 7.53581 -25.1682 -6.10704 -8209 4 36.4508 32.2046 22.7426 1.48893 5.77393 9.47334 -8210 4 35.7934 33.2936 23.5958 -9.41601 17.7382 0.925908 -8211 6 23.6488 31.8764 22.7665 2.85736 4.06253 -9.33391 -8212 4 23.7634 32.5358 22.0878 -9.04528 15.3932 -0.43099 -8213 4 24.3599 31.3007 22.5126 8.23075 -21.5035 13.0322 -8214 6 0.735457 24.4657 41.7131 -9.37188 -1.3071 -20.2528 -8215 4 1.20497 24.8068 40.9273 -3.735 -3.01915 11.177 -8216 4 54.8235 24.2347 41.4089 15.688 5.53844 3.35783 -8217 6 15.9771 8.98022 19.8191 22.6241 -28.8974 20.594 -8218 4 15.5109 8.26292 19.4118 -7.13343 -10.7615 -13.7959 -8219 4 15.6388 9.77471 19.4696 -19.2292 39.8019 -15.8774 -8220 6 33.1716 12.5629 20.0326 13.9441 -12.6476 -4.49459 -8221 4 32.9044 11.6183 19.8429 16.5289 30.3248 6.35834 -8222 4 34.162 12.7185 19.975 -34.5589 -12.2038 -12.3621 -8223 6 7.03971 24.945 26.3683 -0.33354 -9.69316 23.9049 -8224 4 6.80945 24.3756 27.1101 -9.22275 -9.46444 -2.85995 -8225 4 7.84656 25.3251 26.6963 17.391 9.90995 -3.06061 -8226 6 44.4739 22.5508 36.9255 -16.7075 -6.88118 10.4755 -8227 4 43.5027 22.4108 36.9334 15.1456 1.07948 9.67769 -8228 4 44.6732 22.7799 36.0336 3.04889 5.98288 -21.3947 -8229 6 39.2775 23.7142 25.1185 -44.4168 -97.0378 5.9092 -8230 4 39.6033 24.5307 24.937 33.9242 88.3913 -14.6991 -8231 4 38.7559 23.4597 24.3323 8.03463 3.9453 13.1815 -8232 6 20.3756 2.20712 36.9897 -7.56257 -5.27652 1.95266 -8233 4 20.2168 1.45659 37.5665 4.06747 -3.41627 8.94019 -8234 4 20.2802 1.85339 36.1124 5.28277 1.38 -10.8685 -8235 6 22.8571 19.5527 3.6659 6.2145 7.79245 45.4341 -8236 4 22.8782 19.7834 4.64919 -10.5004 -5.13291 -37.3231 -8237 4 23.7426 19.8021 3.38476 9.02488 -3.84737 -6.15569 -8238 6 31.6989 12.5719 34.5929 20.3571 12.3337 69.8717 -8239 4 31.0774 13.2339 35.0297 17.9304 -15.3013 -22.977 -8240 4 32.3378 12.3324 35.3667 -30.4994 7.85147 -45.3393 -8241 6 12.9846 10.2214 25.1019 -30.6317 10.0697 -32.3453 -8242 4 13.6677 9.95937 25.6652 38.8731 -4.05338 37.0168 -8243 4 12.5116 9.4018 25.0264 -11.673 -9.01961 -8.06086 -8244 6 27.2702 0.587979 13.2088 -29.2359 -8.68669 8.17042 -8245 4 27.7024 41.6312 13.2942 -2.56798 3.03598 -7.56301 -8246 4 26.2795 0.464606 13.259 26.6373 -0.778522 -5.81594 -8247 6 5.6575 24.9337 13.9905 13.1991 2.90197 -9.87868 -8248 4 4.70598 24.9553 13.883 -5.9976 0.782062 8.57209 -8249 4 5.90972 25.4072 14.7914 -9.20077 -1.59682 1.38283 -8250 6 22.9799 17.9518 0.527007 -12.0607 -30.0717 13.8125 -8251 4 22.428 18.6392 0.176667 -3.67819 14.6501 -9.17369 -8252 4 22.2816 17.3415 0.914453 31.709 16.1034 -10.9012 -8253 6 33.0985 25.4181 5.46205 -15.7978 -31.0624 1.20161 -8254 4 33.3789 26.3039 5.55078 15.9502 30.9866 -6.27287 -8255 4 32.9645 25.2082 4.52957 3.04969 3.7853 3.27689 -8256 6 8.52872 7.94688 17.4833 18.4257 15.9711 -24.7978 -8257 4 9.39098 8.3855 17.3119 -11.8135 -8.35054 -2.98105 -8258 4 8.4858 7.94817 18.4262 -6.55829 -2.0729 23.5191 -8259 6 26.8237 0.686378 2.88748 4.07 30.2002 2.01549 -8260 4 26.8412 0.391628 3.80568 -3.86709 0.733005 8.35451 -8261 4 26.5975 1.66265 2.91719 8.86873 -29.5911 -1.41132 -8262 6 50.0397 34.7157 15.6267 -11.8175 -1.09292 -1.87233 -8263 4 50.6372 35.2521 15.0721 -14.1207 -5.91477 -4.02646 -8264 4 49.1323 34.6374 15.219 24.748 6.82197 2.94942 -8265 6 46.275 5.00035 11.1282 9.7079 18.7279 -10.06 -8266 4 45.8191 4.20733 11.3912 -11.1099 -14.8598 8.88229 -8267 4 46.9633 4.71614 10.5231 1.70636 -6.51939 -1.67277 -8268 6 33.7833 38.63 35.3851 22.6491 -26.5736 53.3982 -8269 4 34.0604 38.9625 36.3013 -14.2885 -2.00103 -44.5517 -8270 4 33.6201 39.3455 34.786 -2.63152 22.0909 -4.2817 -8271 6 30.8201 25.8435 41.2101 0.522631 -30.718 -12.9218 -8272 4 31.0968 24.9266 41.4082 -1.05643 6.85883 -6.1679 -8273 4 31.1715 26.3436 0.016995 6.66556 20.3816 22.2796 -8274 6 50.2276 0.978128 24.4598 74.6558 22.0158 36.8282 -8275 4 49.5306 0.534407 24.0585 -38.5843 -30.8873 -31.929 -8276 4 51.1134 0.532188 24.3239 -37.6779 9.32343 -0.630533 -8277 6 31.2996 0.720873 19.0302 14.3507 40.5737 -10.6901 -8278 4 30.4605 0.743437 18.5837 -16.9464 -9.10756 -3.3833 -8279 4 31.3343 41.8987 19.5933 -6.31648 -47.867 22.0648 -8280 6 39.0778 29.5479 19.1423 -24.9794 -6.4558 -1.7207 -8281 4 38.1293 29.5816 19.4551 33.1986 -8.08964 -3.40762 -8282 4 39.446 28.6506 19.2986 -6.02354 14.8003 0.990496 -8283 6 21.659 17.5991 25.8953 -11.5386 33.2832 -7.33353 -8284 4 22.0418 18.5204 25.967 -8.02723 -30.5851 6.12101 -8285 4 20.778 17.7492 25.4824 18.7799 -9.30112 4.66445 -8286 6 35.0777 28.803 27.4254 -1.70316 -21.0069 37.4458 -8287 4 35.3301 29.4791 28.0775 3.3924 -2.39002 -8.5847 -8288 4 35.0935 29.2141 26.5843 6.79083 21.8236 -32.9604 -8289 6 30.7137 25.4449 11.6588 -11.4017 25.922 39.321 -8290 4 30.5753 25.9017 12.5616 8.60864 -26.5127 -36.0552 -8291 4 30.5331 26.1452 11.022 4.69716 -0.666916 0.479504 -8292 6 7.33812 15.1344 12.3538 4.68116 -40.544 31.6975 -8293 4 6.75693 14.3594 12.209 2.06777 16.361 -3.14284 -8294 4 7.31295 15.622 11.5607 -9.0052 27.071 -31.8075 -8295 6 16.8334 26.8188 7.04972 -25.5936 3.66279 -30.8653 -8296 4 17.5758 26.708 7.59816 38.4339 -11.2263 23.8467 -8297 4 17.1819 26.9966 6.1597 -5.58153 -2.73835 6.66814 -8298 6 29.5302 33.0784 31.0001 -37.3865 -15.0005 -19.6245 -8299 4 28.6433 32.7554 30.7459 2.04647 15.9344 -4.27919 -8300 4 29.8764 32.2746 31.3613 18.5632 -10.7791 20.7082 -8301 6 14.1048 2.11879 30.9099 -3.69766 -14.7615 43.6071 -8302 4 14.1458 1.95878 31.9138 -8.46722 9.63961 -39.7078 -8303 4 13.6642 1.31591 30.5661 9.09938 8.95306 -0.112961 -8304 6 15.6571 22.2632 2.89617 -37.5764 43.5932 -9.62192 -8305 4 16.4348 21.7941 3.05118 39.5293 -34.0009 4.7875 -8306 4 15.0286 21.6897 2.4522 -3.10464 -12.538 6.06705 -8307 6 23.7259 29.1153 40.9645 17.3396 38.8389 1.6287 -8308 4 23.2818 30.0193 40.9831 11.4767 -32.1544 -0.906545 -8309 4 24.7087 29.2887 40.9216 -25.4222 -7.32646 2.20707 -8310 6 38.1247 14.1642 13.7107 12.8592 31.0763 6.54808 -8311 4 37.6278 13.3808 13.8383 -17.8092 -31.0521 2.1891 -8312 4 38.9029 13.9224 13.2095 7.41852 -3.42228 -8.90759 -8313 6 35.2503 26.5068 15.521 -3.09354 13.3371 19.8917 -8314 4 34.5349 26.5126 14.8818 -0.932758 -4.81772 -4.34805 -8315 4 34.9075 27.0382 16.2823 10.0491 -13.0104 -19.4153 -8316 6 19.0968 34.7379 16.486 5.71756 23.995 22.7437 -8317 4 19.4075 35.6523 16.3704 4.72819 -11.1284 17.3551 -8318 4 19.0401 34.4508 15.6072 -6.41662 -20.6903 -39.0731 -8319 6 18.1723 29.7514 35.7083 20.6671 12.6318 -10.71 -8320 4 18.3041 30.5743 35.1773 -7.60682 -14.8418 20.474 -8321 4 19.0351 29.5718 36.145 -10.3356 2.9076 -6.19235 -8322 6 54.1213 22.2675 24.9131 12.7342 -33.1199 -26.8219 -8323 4 53.6265 21.7967 24.1967 9.15099 10.4438 12.7736 -8324 4 53.5183 22.8995 25.2476 -23.1208 24.5105 7.38222 -8325 6 30.3446 10.3415 34.0026 7.84994 -0.761596 -9.91104 -8326 4 29.5868 10.4349 34.5739 -14.9697 1.07498 11.7851 -8327 4 30.8511 11.1643 34.0933 -4.52293 -3.62201 3.70872 -8328 6 38.3178 33.8965 18.5989 -35.8058 -11.4104 -3.76591 -8329 4 38.923 33.166 18.7063 19.7544 -4.29321 9.06839 -8330 4 38.8137 34.6503 18.3352 23.7539 21.4454 3.52643 -8331 6 22.4873 14.1653 34.4312 -21.9658 -17.0918 -49.1801 -8332 4 22.5571 13.4626 33.7145 -4.81718 29.7264 22.473 -8333 4 23.0772 13.8965 35.1058 26.7449 -1.29975 22.8703 -8334 6 38.021 0.617904 2.36461 -2.26574 -7.91048 -40.4777 -8335 4 37.6239 1.19646 3.0125 3.99393 1.59858 23.4614 -8336 4 38.7851 0.132723 2.71367 -6.22024 4.30596 13.4956 -8337 6 38.885 41.133 10.292 38.4397 69.693 -20.9517 -8338 4 38.7327 0.223589 10.3334 0.502898 -40.1285 -2.38265 -8339 4 38.1678 40.7662 10.7395 -40.074 -22.1176 34.0334 -8340 6 53.417 21.9266 38.962 18.4876 1.53578 17.2983 -8341 4 52.9974 21.8755 38.1026 3.71535 5.74942 -10.4205 -8342 4 54.37 22.1639 38.7939 -25.8904 -11.793 -3.59034 -8343 6 39.9933 12.7125 36.2959 -18.8272 27.1562 12.2819 -8344 4 39.0734 12.4542 36.2547 -7.90274 -1.75871 9.35878 -8345 4 40.3901 12.0873 35.7283 26.8007 -18.4843 -23.2317 -8346 6 48.44 17.2431 40.5981 -19.9836 6.93831 4.04917 -8347 4 47.6199 17.7956 40.4399 22.5854 -23.5642 7.97707 -8348 4 48.3147 16.8142 41.4747 5.07747 10.2388 -9.33604 -8349 6 32.0284 9.3439 40.0151 10.5149 -12.1651 13.6504 -8350 4 32.8546 9.41316 39.523 -1.99935 -3.17675 -6.39298 -8351 4 31.9706 8.39334 40.2816 -10.0936 21.7982 -4.27543 -8352 6 31.75 22.4929 6.3685 -34.2181 3.54143 23.53 -8353 4 31.3779 21.709 6.82557 12.2201 6.35834 -11.7559 -8354 4 31.3059 23.2194 6.8777 16.0591 -13.7554 -15.3432 -8355 6 51.0144 2.58529 21.579 28.4772 -3.64411 10.4611 -8356 4 51.4343 1.72703 21.8198 -11.0001 9.38403 -4.71992 -8357 4 51.7571 3.20177 21.4507 -11.3685 -6.83795 2.38662 -8358 6 13.6247 22.0465 12.1442 29.0901 0.46256 9.76546 -8359 4 14.4578 22.3795 12.5465 -13.9989 1.27328 -8.95219 -8360 4 12.915 22.6494 12.3833 -3.04453 8.5056 -1.94564 -8361 6 23.6209 24.0381 14.6453 -17.5202 11.834 -36.5316 -8362 4 24.2009 24.4886 15.2598 9.8869 4.60732 -3.70937 -8363 4 23.5497 24.6116 13.8304 3.00595 -20.2815 30.972 -8364 6 9.32136 4.85156 31.2387 8.97842 0.466865 -3.67014 -8365 4 8.41764 4.8259 30.9291 -8.7496 -0.132795 -7.84821 -8366 4 9.23666 5.38964 32.029 2.44443 -3.9247 9.21777 -8367 6 16.6769 26.3146 18.0426 -28.7898 -24.0576 -1.25383 -8368 4 15.7763 26.5978 17.7405 22.2361 3.17889 2.46191 -8369 4 17.2688 27.0532 17.9767 7.52301 23.5471 -7.71583 -8370 6 5.12002 13.5179 11.5454 -28.2867 15.553 -42.5279 -8371 4 4.34318 13.4159 12.0982 -3.89331 -5.54815 13.62 -8372 4 4.69334 13.8537 10.6805 23.3071 -7.58808 40.5266 -8373 6 29.613 23.6535 8.07622 4.06305 -5.39054 -18.0309 -8374 4 29.2087 23.3655 8.89798 -2.48969 6.78204 1.65997 -8375 4 29.356 24.5861 7.97247 8.33853 -10.6544 5.22118 -8376 6 0.809058 7.56442 27.8431 6.90575 4.16885 -14.0934 -8377 4 0.916059 7.33161 28.7668 -1.2645 -7.40385 9.39857 -8378 4 1.47033 8.27499 27.7095 -9.19662 -21.8408 -1.77541 -8379 6 15.4183 9.78145 0.490529 10.0725 -7.13925 0.979932 -8380 4 16.087 9.43012 41.8027 -0.259761 -4.12548 -6.98761 -8381 4 15.4693 9.20893 1.26423 -1.27146 5.63374 6.96511 -8382 6 18.8191 0.059487 34.1187 -25.6574 -0.396319 -31.4644 -8383 4 18.4098 41.5755 33.3103 16.2128 4.97009 18.3796 -8384 4 18.5054 0.975155 34.0945 0.533414 5.37151 1.64989 -8385 6 18.7349 30.7803 29.1665 47.4813 -67.7405 25.7886 -8386 4 19.5534 30.6866 29.7899 -42.3671 12.2249 -32.0712 -8387 4 18.5184 31.6699 29.0545 -8.91834 48.7901 3.3651 -8388 6 48.4474 16.4903 36.136 -4.39653 9.55775 -4.4164 -8389 4 47.5651 16.9082 36.2181 15.0357 -0.381514 0.207393 -8390 4 48.471 16.1274 35.2331 3.08724 1.10756 7.15907 -8391 6 43.7979 0.472205 29.2706 42.555 -4.96452 -15.1149 -8392 4 42.8863 0.267919 29.38 -32.9664 -6.64218 10.9475 -8393 4 44.2792 41.5357 29.3524 -8.26894 11.2804 8.78801 -8394 6 16.7205 13.887 21.3769 2.19577 2.66609 -2.49996 -8395 4 16.2052 14.7022 21.5336 6.85381 -11.1318 0.719729 -8396 4 16.6911 13.4037 22.2072 -6.06459 1.50462 5.19021 -8397 6 17.3883 13.4356 26.2524 27.4966 3.2637 -26.6685 -8398 4 18.1303 13.5822 25.5825 -26.8694 -2.13737 32.6247 -8399 4 17.6394 12.6216 26.7148 -3.51452 -0.718268 0.201186 -8400 6 48.1557 10.2329 23.6958 7.66187 -11.6345 21.9365 -8401 4 48.0869 10.5828 24.5972 -4.20109 -8.3855 -4.21906 -8402 4 47.9242 10.9774 23.1563 3.12678 5.33996 -12.4543 -8403 6 28.2651 17.9126 17.8865 15.704 23.8601 -19.8805 -8404 4 29.0328 18.4581 17.6288 -8.16305 -6.08358 1.86534 -8405 4 28.6272 17.0995 18.2183 0.672722 -20.799 10.0784 -8406 6 54.0866 38.1772 23.6885 15.2416 -7.03948 -9.32302 -8407 4 0.015845 37.9236 23.4759 -13.1891 10.5947 7.1207 -8408 4 53.5403 37.6177 23.1226 -4.14834 -2.69562 5.50015 -8409 6 8.47885 18.3973 11.4073 -18.4373 -13.8141 42.9629 -8410 4 7.63335 18.6519 11.0416 -6.40415 6.02722 -6.48684 -8411 4 9.12927 18.583 10.7796 32.3175 8.52747 -41.6205 -8412 6 45.9451 12.8796 11.0371 -17.0736 -2.86831 -37.3051 -8413 4 46.6905 12.613 10.4807 4.61659 2.073 6.35499 -8414 4 45.2044 12.775 10.3831 8.06265 2.44535 24.075 -8415 6 16.2127 8.79404 14.0297 41.7324 -66.6139 22.361 -8416 4 15.4739 9.28873 13.8367 -45.7772 50.9633 -18.0772 -8417 4 17.0286 9.27652 14.012 9.93977 26.888 -8.08533 -8418 6 42.7214 13.3612 21.3881 16.6788 44.7105 -2.77317 -8419 4 41.8036 13.1589 21.3301 -20.1042 -28.5105 -1.62877 -8420 4 42.6833 14.2978 21.1276 5.52546 -8.26362 1.62797 -8421 6 21.0018 40.4256 16.4674 21.2457 -19.0828 1.73859 -8422 4 20.7372 40.049 17.3276 2.67731 3.65462 -7.46566 -8423 4 21.8606 39.9985 16.1939 -29.0987 10.293 9.55187 -8424 6 45.6337 11.4313 32.9356 51.1157 -40.0447 2.01383 -8425 4 46.3303 10.7696 33.2563 -29.172 28.0234 -20.2541 -8426 4 45.1866 11.676 33.7277 -20.3741 9.53259 21.5498 -8427 6 26.9484 8.87146 24.2965 48.4346 1.85391 18.4292 -8428 4 27.5311 9.68141 24.3337 -29.9021 -15.2605 -8.39328 -8429 4 27.4823 8.26118 24.8676 -16.4416 6.67878 -12.0087 -8430 6 18.977 2.43413 29.3663 0.758316 16.52 -7.40381 -8431 4 18.1944 2.4248 29.9271 -0.767207 -2.12047 7.99903 -8432 4 19.1173 3.36872 29.101 -3.03797 -9.07666 7.57415 -8433 6 8.2454 29.1679 19.723 -8.63488 -12.9151 21.1286 -8434 4 8.14448 28.8871 20.6627 3.14293 7.67545 -21.2948 -8435 4 7.83715 28.464 19.1969 -1.03495 3.62674 2.54809 -8436 6 9.03976 34.3129 18.6533 -7.54593 -6.72093 -3.09965 -8437 4 8.77081 34.2931 19.577 -0.177883 2.97642 -7.59668 -8438 4 9.06659 35.2455 18.4187 6.50563 1.62734 -4.46359 -8439 6 10.1892 11.9266 11.2355 -21.5107 11.0325 -1.739 -8440 4 10.2333 12.874 11.065 17.4692 -2.43612 -1.88546 -8441 4 9.23632 11.7983 11.121 5.09535 -6.80078 4.24402 -8442 6 35.7546 21.6858 36.1669 -23.2352 21.9394 0.834429 -8443 4 35.0265 22.3595 36.1433 18.2091 -18.4066 2.26802 -8444 4 36.3924 22.0173 36.8321 -9.99636 -6.87572 -9.75527 -8445 6 17.0812 12.5048 36.3903 -12.1142 25.6516 12.5185 -8446 4 17.3175 12.8308 37.2812 -0.49448 -9.18651 -10.1264 -8447 4 17.5662 11.7075 36.2155 7.76979 -20.5663 -1.07791 -8448 6 37.1566 13.0227 34.2843 -17.9764 -6.1284 -55.2853 -8449 4 36.5549 12.2662 34.3472 4.68366 1.60167 -17.3784 -8450 4 37.3932 13.1268 35.1567 14.9075 13.7384 64.605 -8451 6 38.9862 29.5501 13.2301 -1.89389 21.6683 -7.70005 -8452 4 38.7944 28.7085 12.8419 -2.19861 -17.9948 -10.7911 -8453 4 38.6501 29.4932 14.1174 1.27468 3.77518 16.782 -8454 6 0.176516 29.3495 29.4845 -12.5141 10.2637 -5.31555 -8455 4 0.737394 28.6151 29.2028 3.82179 3.49987 -8.15609 -8456 4 54.9814 29.9211 28.6995 5.57042 -17.7863 13.6106 -8457 6 15.9458 0.256833 12.7596 -44.0073 4.56069 2.48191 -8458 4 15.316 0.578271 12.0799 19.6091 -0.692249 -3.06606 -8459 4 15.3039 41.7798 13.3939 19.5978 -0.7471 3.56907 -8460 6 3.99127 11.9482 8.78851 -15.4327 -39.7622 32.4444 -8461 4 4.35413 11.6179 7.97869 6.27746 3.41828 -23.4587 -8462 4 3.98972 12.8788 8.75552 1.02746 43.1268 -6.73396 -8463 6 24.041 23.6822 19.9783 33.1595 11.366 0.122861 -8464 4 23.6132 22.8866 19.7159 -20.0299 -17.1205 -2.84168 -8465 4 23.4218 24.2757 20.3917 -9.46777 4.2557 4.80954 -8466 6 4.48057 2.29323 23.9805 -22.9759 10.1361 69.4322 -8467 4 4.73792 2.40802 23.1034 3.49419 10.2026 -52.1527 -8468 4 3.69711 2.85929 24.1902 11.7092 -10.5693 -13.4065 -8469 6 33.0966 27.663 33.8386 -28.073 -12.9468 -7.71443 -8470 4 33.3687 28.5694 33.7309 6.85765 13.8135 -2.76136 -8471 4 33.7449 27.1385 34.2981 13.436 1.78162 12.2729 -8472 6 11.3912 21.7129 6.08719 -17.5666 -2.19741 -2.39462 -8473 4 12.3323 21.6847 6.05692 28.5529 -3.65784 2.285 -8474 4 11.1694 22.1681 5.26899 -4.22105 -2.6604 -2.39966 -8475 6 37.2225 13.5364 23.6261 -18.6729 23.2035 4.88571 -8476 4 37.3138 14.0862 24.4412 -7.0733 -14.7121 -13.3014 -8477 4 37.9734 12.9786 23.5155 30.7338 -8.31921 -1.90296 -8478 6 5.00503 21.0366 33.3647 1.8453 38.5327 -33.3657 -8479 4 4.21257 21.4237 32.9267 15.1329 -13.9269 -2.57683 -8480 4 4.69097 20.5075 34.0602 -12.1996 -25.3348 31.8286 -8481 6 18.1998 37.5792 26.9379 10.6598 2.97497 -14.5277 -8482 4 17.7896 38.4267 27.1371 3.99806 -1.69574 -0.528064 -8483 4 18.8493 37.7746 26.2284 -6.0853 -8.42077 12.5802 -8484 6 19.7447 16.1537 4.6847 3.25094 -1.99961 -5.02271 -8485 4 18.927 15.8729 5.11398 3.02189 5.09699 3.93014 -8486 4 20.4865 15.8366 5.22215 -5.31395 3.35724 3.77112 -8487 6 54.074 32.5125 15.5854 10.3761 -37.3618 -30.9158 -8488 4 54.8842 32.2065 16.0104 -1.29748 4.29224 -6.87141 -8489 4 53.7047 33.0976 16.2003 -18.9781 34.1452 25.1436 -8490 6 31.1314 3.81684 36.7321 -0.834289 -2.49025 -7.10722 -8491 4 31.1103 4.02948 37.6722 -6.54843 -2.60835 4.18586 -8492 4 30.7135 2.95482 36.5673 3.74099 5.55874 7.56308 -8493 6 11.8386 14.3591 5.9475 31.6488 6.08621 47.6135 -8494 4 11.9235 13.4381 5.72501 -3.84758 -8.60837 -9.73648 -8495 4 12.4264 14.4198 6.78937 -30.0453 0.761866 -39.8937 -8496 6 30.4739 33.6971 6.46755 -23.3776 20.1936 16.0158 -8497 4 30.0841 33.0849 7.09297 -6.22519 -2.1618 10.9649 -8498 4 31.0937 33.1726 6.0102 25.8315 -23.5027 -25.5745 -8499 6 12.7945 0.536645 21.6661 -31.9857 18.4102 -14.2222 -8500 4 12.046 0.975194 21.1709 21.6431 -18.6961 6.09473 -8501 4 12.7507 0.998686 22.5059 13.427 -0.157027 11.5383 -8502 6 52.7685 7.22113 26.1957 6.97037 27.5507 21.845 -8503 4 53.4259 7.92282 26.4698 -21.5773 -21.2317 -16.9414 -8504 4 53.0823 6.78628 25.4103 4.46247 -3.68205 -10.7225 -8505 6 39.7279 40.8849 3.7445 22.9677 17.8938 -40.8272 -8506 4 39.3244 40.0392 3.76563 -12.6427 -25.5287 10.0743 -8507 4 39.6614 41.3038 4.58361 -3.65945 6.85452 27.763 -8508 6 20.1085 31.9188 21.9984 -7.05206 -5.67602 7.13377 -8509 4 19.4287 32.0842 22.6964 14.9272 -8.91322 -13.6161 -8510 4 20.3617 32.7769 21.6609 2.64243 15.0084 0.0829653 -8511 6 12.8674 35.0052 4.44359 43.5281 -46.0898 9.1613 -8512 4 12.2643 35.7062 4.40975 -34.4326 42.8527 -2.74399 -8513 4 13.784 35.3443 4.35073 -14.7319 6.47242 -4.65586 -8514 6 24.0589 33.6612 24.8588 9.55704 11.7193 -6.52578 -8515 4 23.7303 32.9012 24.3903 -5.13736 -12.3884 -10.0474 -8516 4 24.8786 33.8838 24.3903 -2.58553 -1.28908 -1.69824 -8517 6 40.1426 40.9082 22.7393 38.5538 -20.8809 37.5387 -8518 4 39.5402 41.0833 22.0513 -32.6743 7.60774 -19.3027 -8519 4 39.6696 40.5795 23.5226 -1.01773 2.4492 -9.99125 -8520 6 15.5532 2.81426 38.4448 -20.0738 34.0709 23.3703 -8521 4 14.8967 3.48174 38.7749 9.17215 -23.4566 -12.8824 -8522 4 16.1607 3.33672 37.9186 19.8661 -0.634992 -1.43825 -8523 6 41.016 9.18565 16.9561 17.4117 -10.7022 -18.9926 -8524 4 41.8597 8.69641 16.8054 -9.41989 12.8418 6.23764 -8525 4 40.6131 8.73354 17.6887 -9.17188 -2.41438 15.2761 -8526 6 43.1923 41.3931 9.58697 -22.3356 -19.1489 -3.62619 -8527 4 42.3612 40.9845 9.24256 14.3618 0.824315 8.65898 -8528 4 43.3433 0.185675 8.9708 1.58778 19.1204 -6.9238 -8529 6 24.903 37.9158 30.7914 -43.8554 -5.41491 21.3724 -8530 4 23.952 37.804 31.173 48.4757 4.96182 -14.1951 -8531 4 24.7905 38.4252 29.9913 -4.69729 3.46822 -12.8277 -8532 6 2.22055 5.32897 16.4318 -0.704957 11.5959 2.51569 -8533 4 1.8086 4.56809 16.8519 3.25773 -6.94195 4.1641 -8534 4 3.17492 5.17974 16.3235 -2.45649 -10.6256 -1.35481 -8535 6 1.39662 14.9371 19.1386 6.71081 10.2639 18.1623 -8536 4 0.558182 14.6006 18.8448 -10.0768 -10.7254 -15.2923 -8537 4 1.25744 14.8844 20.1022 8.06638 5.64899 -3.4629 -8538 6 34.3184 26.5435 23.7018 12.956 38.2174 -10.8067 -8539 4 33.6096 26.6326 23.0506 -6.28704 -5.42218 7.19498 -8540 4 34.253 25.729 24.1673 -8.0715 -30.4977 4.91012 -8541 6 41.932 21.8144 37.5476 -28.1346 24.458 10.6264 -8542 4 41.9653 21.2973 38.3662 8.82952 -0.726087 -9.88338 -8543 4 41.2985 22.5209 37.8344 14.7394 -10.5077 -10.9774 -8544 6 39.4289 37.6722 12.6363 -7.06663 36.6798 -8.56095 -8545 4 38.7214 38.0767 13.1674 9.12422 -13.2372 3.4836 -8546 4 39.8791 38.4903 12.2996 -0.376717 -30.7746 7.3995 -8547 6 30.2308 35.8744 2.88429 56.3256 -5.17531 19.584 -8548 4 29.7395 35.078 2.8871 -14.5394 -27.2578 -4.40621 -8549 4 29.6846 36.541 2.55195 -33.266 39.3858 -14.7027 -8550 6 50.3691 12.2996 11.0379 -10.7742 -32.245 -38.7061 -8551 4 50.5492 13.1381 11.4098 4.20277 26.7051 25.7379 -8552 4 50.0731 11.6929 11.7162 -2.05651 -3.66514 15.0978 -8553 6 38.4203 1.52686 34.6552 6.3891 -23.1477 32.9209 -8554 4 38.2942 1.9363 33.8354 -7.66336 30.6162 -40.7111 -8555 4 38.1079 0.632206 34.5078 -6.35148 -11.0336 -1.97829 -8556 6 23.4679 32.2557 29.2149 -43.4567 -12.6916 53.2324 -8557 4 24.0296 32.8423 28.7424 12.6247 17.2837 -9.6693 -8558 4 23.1232 32.6929 30.0761 24.9901 -11.6617 -44.232 -8559 6 36.561 38.8488 8.89417 42.7368 2.70764 46.8348 -8560 4 35.962 39.5202 8.64255 -29.9788 24.4889 -23.0747 -8561 4 36.8832 39.1244 9.78764 -11.193 -6.37855 -17.8717 -8562 6 35.882 15.8491 32.4345 4.38917 24.4094 -11.8898 -8563 4 36.1253 15.4284 33.2547 4.1797 -3.844 11.2859 -8564 4 36.4849 16.63 32.3181 -12.6028 -21.8682 2.29862 -8565 6 22.2747 21.8257 41.5848 1.63659 45.0851 -0.0273952 -8566 4 22.1351 22.8132 41.5538 -4.13496 -33.3395 13.1468 -8567 4 23.0832 21.7834 41.079 15.3069 -18.439 -3.51535 -8568 6 24.3693 38.6933 37.0124 5.99709 22.8296 -9.01594 -8569 4 25.2224 39.1901 37.0147 -13.2325 -18.2305 -0.0611307 -8570 4 24.4452 38.0141 37.6805 1.8393 -10.9749 7.25289 -8571 6 45.85 22.0674 16.0435 -6.35855 -11.009 -33.5755 -8572 4 46.1693 22.2375 15.1223 -5.70657 5.73574 25.2515 -8573 4 45.3177 21.2496 15.9445 13.424 8.98362 5.88408 -8574 6 34.0938 26.1451 39.6028 29.3502 -8.72422 32.5359 -8575 4 33.1775 26.2044 39.4639 -36.6108 3.5864 -15.8394 -8576 4 34.1454 26.1252 40.583 9.60862 3.8872 -14.9166 -8577 6 7.22316 36.161 23.2803 -75.9344 2.48999 -44.2827 -8578 4 7.2061 37.0658 22.9632 2.60813 8.07149 -4.69042 -8579 4 7.98979 36.1134 23.7455 79.8131 -8.28428 52.3852 -8580 6 29.1469 40.7664 9.14908 25.9603 -62.9641 -41.536 -8581 4 29.104 40.2522 8.28913 -11.1672 35.4313 19.904 -8582 4 29.7179 40.1086 9.59652 -3.22944 23.7461 21.8778 -8583 6 29.3725 11.2348 1.3024 -38.7794 14.8627 17.4065 -8584 4 28.4703 11.3821 0.891273 31.6728 -0.63192 16.6295 -8585 4 29.2803 11.4968 2.26097 5.36173 -12.1272 -32.3877 -8586 6 30.9813 3.70043 14.0775 0.393287 -12.1193 -7.6118 -8587 4 31.3533 2.81844 14.3971 -7.37725 32.1126 -17.4345 -8588 4 30.796 3.71521 13.098 8.52465 -17.2224 25.8707 -8589 6 29.7018 15.2871 38.2765 -11.7342 18.5436 -44.4423 -8590 4 30.2882 15.1814 38.9925 24.3773 -7.28175 32.8118 -8591 4 30.1059 15.9805 37.6877 -12.7379 -16.9908 17.8861 -8592 6 36.618 0.316233 29.1564 -1.13478 17.6011 -18.8673 -8593 4 37.4497 0.805382 29.2328 -0.537074 -5.31334 10.7084 -8594 4 36.0611 0.935156 28.6408 3.38103 -20.3125 11.7491 -8595 6 47.6566 0.117823 23.249 5.11875 5.73062 -10.5794 -8596 4 46.969 0.414744 23.8324 -12.4062 9.53281 16.9836 -8597 4 47.4018 41.1354 23.0496 0.315762 -17.3342 0.264415 -8598 6 7.91605 37.1729 29.9478 9.96828 38.7234 29.3851 -8599 4 7.8238 37.3188 30.9485 4.22886 -13.4646 -46.5453 -8600 4 8.48708 37.9472 29.6677 -24.8232 -29.7333 9.09982 -8601 6 38.925 24.2263 12.6374 28.6028 -18.1679 -25.4959 -8602 4 37.978 24.1747 12.7226 -16.6271 -1.4443 2.40459 -8603 4 39.1586 23.5255 11.9538 -9.24307 26.9603 22.464 -8604 6 21.3053 26.2545 36.7859 14.9917 45.9325 1.16 -8605 4 20.8074 25.7232 36.1994 -14.2562 -21.9874 -17.8757 -8606 4 21.6248 25.6951 37.4625 3.91421 -21.0802 23.8691 -8607 6 28.2258 23.3284 24.9888 19.6442 1.87868 9.60148 -8608 4 28.2493 24.0261 25.6588 -3.93467 -3.60043 -2.01642 -8609 4 29.1002 22.8932 25.0573 -18.3502 1.43704 -4.70914 -8610 6 38.4116 39.5691 14.5896 29.669 -4.24194 25.1928 -8611 4 38.4978 38.8692 15.3261 -6.52385 31.9806 -37.1925 -8612 4 39.2924 40.0897 14.6163 -46.5668 -30.9815 -6.21074 -8613 6 26.0432 5.99751 38.1148 44.5658 1.98351 30.7371 -8614 4 26.452 6.86444 38.1066 -12.5768 15.2327 -11.4433 -8615 4 26.7959 5.51316 38.5398 -27.2991 -6.53191 -16.0548 -8616 6 52.1237 17.2497 22.5073 -27.4301 16.765 14.7973 -8617 4 52.9399 17.665 22.2571 16.5652 5.20466 -11.3284 -8618 4 52.1578 16.3131 22.3678 7.8945 -19.2066 -9.92552 -8619 6 39.5302 30.1999 31.4498 -15.3908 2.56685 75.4769 -8620 4 40.0207 30.5437 32.2484 0.473519 -4.28305 -35.1019 -8621 4 38.713 29.8928 31.926 18.6512 10.8404 -28.7426 -8622 6 19.6503 6.93083 12.7623 15.8343 -24.4908 21.6207 -8623 4 19.8732 6.46228 13.5959 -20.1786 11.9342 -5.76682 -8624 4 20.303 6.55009 12.1776 -0.0209149 2.55819 -14.5973 -8625 6 32.4196 37.4972 40.0987 12.4446 10.4582 -32.0511 -8626 4 32.8186 36.647 40.0719 9.51079 -23.9505 -16.9607 -8627 4 32.1638 37.519 40.9804 -20.9873 13.1856 56.2462 -8628 6 39.7646 0.344956 6.09395 -0.813604 -13.3118 11.6504 -8629 4 40.0929 1.25666 6.05063 3.72657 -6.06719 5.14874 -8630 4 40.1279 41.7919 6.88268 -2.2039 13.7644 -10.8213 -8631 6 28.7754 10.1494 29.1547 6.27663 8.45441 -17.0952 -8632 4 27.8341 10.1814 28.9557 -5.13507 -0.906004 3.81537 -8633 4 28.9096 9.91312 30.0774 -3.02611 -6.60467 -0.689697 -8634 6 28.3509 21.0738 10.6423 20.1214 -0.517468 -23.7169 -8635 4 28.7452 21.9678 10.604 -10.1652 -7.70852 11.001 -8636 4 28.9796 20.5469 10.1008 -17.263 7.26144 14.8814 -8637 6 27.0689 28.6853 20.8654 35.4789 -5.63144 4.47554 -8638 4 27.7442 29.2307 21.3162 -7.53329 -4.62114 -3.00727 -8639 4 26.2324 28.9644 21.1916 -29.8949 8.87289 15.491 -8640 6 39.6884 13.9755 33.4499 14.6401 2.99861 16.5486 -8641 4 40.0373 13.7827 34.3426 -3.85296 -1.51256 -14.2832 -8642 4 38.7457 13.8219 33.5285 -9.87208 -9.87778 -3.27097 -8643 6 25.4679 11.6581 34.316 -5.2989 -28.5582 40.5924 -8644 4 24.7613 11.1605 34.7897 20.9725 -0.466275 -6.59756 -8645 4 25.003 12.0579 33.6214 -16.717 25.3404 -32.2266 -8646 6 27.5101 37.647 21.4263 -39.7295 -31.2682 -35.969 -8647 4 28.2375 37.1633 21.0518 17.2189 -6.02702 -9.55939 -8648 4 27.8241 38.1534 22.1272 30.3423 24.6719 41.8853 -8649 6 30.5838 20.0489 28.6446 73.221 13.9737 -1.42059 -8650 4 31.1441 19.3945 29.1273 -28.9524 12.9537 -8.0961 -8651 4 29.6632 19.9528 28.6439 -45.0502 -19.2043 6.90743 -8652 6 42.3833 1.8554 14.9243 13.367 3.08275 38.4467 -8653 4 41.8907 2.29225 15.634 5.99337 6.74303 1.17955 -8654 4 41.7769 1.84183 14.2131 -17.6385 -4.20156 -32.9301 -8655 6 12.1633 12.5377 19.5325 -23.0245 -19.867 -11.1113 -8656 4 12.9521 12.0237 19.3369 9.43068 0.576721 5.46819 -8657 4 11.4219 11.8853 19.4518 12.4737 16.4774 1.27947 -8658 6 19.216 1.20416 16.3541 12.5689 2.54581 22.2585 -8659 4 19.6937 0.628292 16.9879 -4.91383 6.35485 -14.1526 -8660 4 19.7889 1.98236 16.2594 -2.22189 -4.72354 -7.2618 -8661 6 9.47695 16.1439 27.6873 23.0793 15.684 -40.8775 -8662 4 9.87411 15.9669 26.7875 -8.00596 11.4199 30.6292 -8663 4 9.27844 15.2819 28.0019 -12.6146 -24.0632 14.4486 -8664 6 40.4558 26.1873 24.7848 -5.87099 -8.07067 -10.9608 -8665 4 40.3772 26.6753 25.6381 -3.45584 0.121614 -18.2296 -8666 4 40.075 26.6842 24.0102 9.21367 0.234889 33.0434 -8667 6 47.6742 17.6493 18.027 -37.0889 26.6143 -3.73366 -8668 4 48.2089 18.0323 18.7522 -4.76487 -3.2939 -8.20899 -8669 4 46.8388 18.2201 17.9217 41.9344 -19.3622 12.4897 -8670 6 36.6073 25.2802 4.19388 18.2149 -9.73143 -24.5863 -8671 4 36.604 25.3887 5.14943 -0.00537736 13.7381 3.83127 -8672 4 37.3627 25.7621 3.76942 -18.9403 0.329358 18.8416 -8673 6 39.5721 35.375 29.6682 7.39129 29.0443 4.37935 -8674 4 38.9992 34.6325 29.7528 -8.39079 -18.7886 -5.10368 -8675 4 39.3389 35.9401 30.4162 6.41301 -4.37294 -4.4287 -8676 6 0.402862 14.6299 13.3406 12.3375 -5.37043 -32.3015 -8677 4 54.737 15.2477 13.6388 -5.18731 7.44473 4.40324 -8678 4 0.540834 14.0191 14.0401 1.19186 -14.994 25.3978 -8679 6 12.2127 27.3484 8.43247 -29.2387 -0.771708 1.75024 -8680 4 12.965 26.7512 8.46983 14.5311 5.0326 6.8656 -8681 4 12.3156 28.1607 8.97491 11.1816 -11.3427 -11.9337 -8682 6 36.8986 14.8167 21.1188 31.0797 27.7575 -31.2238 -8683 4 37.0397 14.394 21.9547 2.6333 -10.7207 26.6181 -8684 4 37.7308 15.3371 20.9125 -24.2604 -24.0664 4.77074 -8685 6 20.8464 4.94114 21.1044 31.4042 5.97012 13.2179 -8686 4 20.3644 5.60924 21.5958 -5.50293 4.43366 -4.7096 -8687 4 21.773 5.03668 21.4416 -23.5272 -13.3128 -11.683 -8688 6 36.7544 1.79945 7.61694 -30.3574 47.6061 45.3867 -8689 4 36.327 2.6686 7.87118 16.8784 -26.1974 -29.8241 -8690 4 36.8428 1.50799 8.53455 15.1793 -22.3797 -11.8231 -8691 6 12.2439 31.5023 37.4569 -32.4985 -2.96535 6.06153 -8692 4 12.7586 31.1596 36.7365 10.4364 1.05198 -9.11954 -8693 4 11.3919 31.0227 37.3953 11.2973 8.58078 9.3944 -8694 6 38.9908 41.586 16.881 -5.73716 8.1645 -10.5856 -8695 4 39.3046 41.7073 15.9766 4.30886 -9.33368 3.06156 -8696 4 39.3667 0.405687 17.3669 3.77504 10.3777 9.96207 -8697 6 31.8904 27.2678 22.2602 -2.97266 4.85738 -46.2508 -8698 4 31.2122 26.6002 22.3915 1.88455 0.488126 10.0993 -8699 4 31.7489 27.4981 21.2895 3.71213 -3.79941 38.8104 -8700 6 42.7405 9.18554 25.589 -22.1194 -12.6454 -9.25487 -8701 4 42.0872 8.82691 24.9599 0.650449 1.17306 7.26361 -8702 4 43.4011 9.54846 25.0154 21.3216 10.0262 -4.62936 -8703 6 50.9383 28.1736 25.3544 -13.6318 0.0171378 28.1732 -8704 4 50.4953 27.5553 24.7803 -5.9639 1.72187 -15.2616 -8705 4 50.5272 27.9992 26.2251 14.2447 5.57945 -12.3971 -8706 6 43.1888 19.6578 30.9105 -66.6531 23.7889 25.5358 -8707 4 44.0873 19.829 30.8982 70.1332 9.75906 -5.84371 -8708 4 42.7965 20.4661 31.3425 9.97757 -17.7871 -10.1322 -8709 6 30.6644 14.0457 40.7997 -18.1309 16.7334 54.243 -8710 4 30.3214 14.3504 41.7092 15.0959 -2.90855 -40.5845 -8711 4 30.1739 13.231 40.7145 -1.19418 -16.8866 -12.4659 -8712 6 20.9131 15.4897 23.0235 5.61878 12.7036 12.8066 -8713 4 20.368 16.1905 23.4302 1.66694 -9.32372 -6.67403 -8714 4 21.8218 15.751 23.2692 -7.37195 -9.57776 -6.18749 -8715 6 34.2171 0.764056 35.8253 8.40959 -35.3498 44.9304 -8716 4 34.6567 1.46863 36.3417 -5.08936 -9.30099 -7.81199 -8717 4 34.1194 41.866 36.4755 2.29033 39.9746 -37.3302 -8718 6 38.9162 36.9098 35.9203 10.0793 6.80115 3.36275 -8719 4 39.7784 37.1612 36.3284 -16.0364 -11.2649 -5.21842 -8720 4 38.6132 36.0588 36.2696 9.66804 2.35098 0.533126 -8721 6 45.1336 25.2146 22.7744 -28.8992 3.863 21.2581 -8722 4 44.1561 25.0943 22.7165 17.1243 8.87651 18.653 -8723 4 45.3983 24.7563 22.0047 17.0602 -12.3694 -29.5411 -8724 6 40.597 0.8134 35.9421 3.227 69.6319 -3.88491 -8725 4 40.5509 41.8059 36.0096 -6.03355 -53.2669 -4.53187 -8726 4 39.9427 1.13471 35.2813 10.0151 -17.6297 16.5691 -8727 6 11.0455 28.3465 35.0235 9.7668 1.71998 -0.601403 -8728 4 10.9819 27.7367 35.7737 -0.960779 4.073 1.47136 -8729 4 10.3922 29.0422 35.1677 -11.8786 -4.48184 3.12795 -8730 6 20.2051 13.5934 35.8566 39.7213 -43.4527 45.4399 -8731 4 19.4813 14.0017 35.4777 -48.9883 30.031 -35.164 -8732 4 20.9868 14.0394 35.5673 14.4182 15.1 -18.5178 -8733 6 39.6245 5.13776 1.76997 -0.951619 9.89005 21.073 -8734 4 38.8252 4.77089 1.41386 -14.9185 -6.12031 -3.7056 -8735 4 40.3018 4.93211 1.13633 15.4903 5.30459 -14.5773 -8736 6 30.2698 30.8736 32.4375 -6.71798 15.6036 14.0469 -8737 4 29.6901 31.1438 33.1751 5.76607 1.99955 -8.25679 -8738 4 29.7896 30.1731 32.0039 1.14172 -17.9152 -6.50707 -8739 6 14.5598 11.0088 22.8703 10.5759 -0.53797 13.7125 -8740 4 15.2344 11.6195 23.3114 -32.0235 -23.0075 -11.5695 -8741 4 13.848 10.7777 23.5118 19.1574 10.2796 -1.34673 -8742 6 20.7379 13.9443 3.00881 5.16887 -45.0314 -26.4616 -8743 4 19.9261 13.6658 2.50706 22.866 18.233 23.793 -8744 4 20.5244 14.6819 3.55007 -16.1173 25.3417 12.2311 -8745 6 41.3029 4.28468 12.6203 -8.04128 10.917 21.7417 -8746 4 40.6152 3.63858 12.7642 -6.82471 -4.23516 2.09603 -8747 4 41.6484 4.11485 11.7651 11.719 -9.67534 -28.974 -8748 6 10.8581 24.7328 21.7161 -39.3585 -15.8792 -33.4515 -8749 4 10.0068 24.8598 21.1989 28.1112 14.2693 20.1969 -8750 4 11.1639 23.9123 21.3137 10.3572 -6.50453 7.69671 -8751 6 53.5762 20.8825 34.3773 -29.6915 -0.0415475 -3.94304 -8752 4 54.5085 20.795 34.3185 33.8519 4.29786 -2.30511 -8753 4 53.2552 20.0612 34.7861 8.83511 12.9473 -9.59804 -8754 6 14.8838 4.84499 30.449 -1.65326 0.839716 -13.8987 -8755 4 14.8578 5.00753 29.4799 -4.93385 -7.75961 17.951 -8756 4 14.5437 3.94124 30.5804 2.28716 7.27432 -2.63088 -8757 6 48.9137 37.1159 13.1232 -44.1315 32.6594 -31.0851 -8758 4 47.9268 37.1149 13.1949 24.5681 4.85746 10.1076 -8759 4 49.2024 36.4546 13.7037 17.9017 -30.2536 24.0784 -8760 6 26.8017 19.3068 7.5379 -15.1037 -1.6612 14.6377 -8761 4 27.3245 18.5243 7.34583 -2.01051 -6.65035 -9.19035 -8762 4 27.3053 20.0577 7.2492 18.4232 10.5976 -10.0514 -8763 6 17.631 11.9383 39.0904 -43.3265 13.8677 10.122 -8764 4 18.4941 11.6307 38.9203 38.4816 -13.6738 2.54756 -8765 4 17.5009 12.0978 40.0481 6.31677 -1.58465 -10.4285 -8766 6 49.9233 14.5931 8.61354 5.83785 -36.2985 -8.08798 -8767 4 49.214 13.9285 8.60404 6.89175 6.08198 5.75816 -8768 4 49.5175 15.3796 8.93642 -5.42274 33.9852 6.11405 -8769 6 32.3642 34.9667 31.5078 2.95354 23.7899 20.5819 -8770 4 32.072 34.4222 30.8036 -4.84614 -18.7532 -16.6478 -8771 4 32.4643 35.8463 31.1217 -0.970967 -0.757054 5.3462 -8772 6 11.8286 22.2266 21.3061 -17.2258 -15.6378 -41.9552 -8773 4 12.2171 21.6669 20.5638 -11.8041 19.7065 26.8676 -8774 4 12.3859 22.1258 22.0497 29.6948 -3.02551 21.8379 -8775 6 33.8509 9.96106 13.6416 -14.3875 -24.3714 -53.1057 -8776 4 33.0123 9.50508 13.4028 8.15621 17.9807 22.2309 -8777 4 34.3201 9.78154 12.7883 7.50726 12.1846 28.7729 -8778 6 25.5192 36.3946 1.51103 -10.4602 3.19395 -11.4439 -8779 4 26.0842 36.7323 0.810141 8.62195 6.50952 5.56913 -8780 4 24.6933 36.9065 1.40961 6.72848 -10.059 1.65156 -8781 6 26.2721 10.5411 9.76409 -19.2005 -4.19702 2.88354 -8782 4 25.6096 11.193 9.42675 5.9346 -6.99241 18.1855 -8783 4 25.839 9.94226 10.4354 7.43867 25.8511 -14.7334 -8784 6 25.016 0.794303 40.8954 13.3669 6.17095 4.00755 -8785 4 25.3682 0.342397 40.1084 -6.19889 9.04785 1.09472 -8786 4 25.4075 1.69244 40.9338 -2.19893 -14.7289 -5.24662 -8787 6 46.2434 3.93626 24.8203 6.94819 -22.6825 -8.03363 -8788 4 46.3834 4.04208 23.8743 3.61713 6.01616 -2.12387 -8789 4 46.2394 2.96647 24.9181 -8.37252 7.22853 3.62774 -8790 6 21.5889 13.6037 29.2057 4.95103 8.76674 17.4208 -8791 4 21.6019 14.3052 29.8879 -2.51331 -9.966 -5.68557 -8792 4 21.3126 14.082 28.4253 -2.16645 0.501775 -6.52993 -8793 6 36.7737 38.3803 0.360926 -13.0762 -25.442 -6.6792 -8794 4 36.4499 39.0355 0.978203 -4.80976 12.188 0.88021 -8795 4 36.0266 37.7487 0.22189 15.835 12.8395 4.19355 -8796 6 19.3086 17.6338 24.0617 47.0109 35.6134 -17.5995 -8797 4 18.4263 17.3722 24.1632 -50.3154 -15.1751 2.93786 -8798 4 19.3137 18.3511 23.365 -2.62926 -22.9616 14.087 -8799 6 23.1803 12.6945 3.50697 -12.4047 4.12184 -0.296296 -8800 4 22.2521 12.9621 3.30307 10.5621 -3.58256 -0.535563 -8801 4 23.3663 11.8631 3.0578 -9.23841 -1.30096 -1.53094 -8802 6 37.8891 8.88353 35.4651 -18.9945 -25.3999 -47.3866 -8803 4 38.8166 8.83127 35.1934 2.77199 2.98421 7.2207 -8804 4 37.4068 8.32521 34.752 23.9265 29.6152 37.0755 -8805 6 14.3237 15.1253 36.1844 10.7536 -1.62675 -12.1114 -8806 4 15.0418 15.7291 36.3902 7.37284 -3.65767 0.0646607 -8807 4 13.765 15.154 36.9379 -17.7819 2.51157 18.8211 -8808 6 35.0801 0.941274 33.018 -10.8249 30.7834 33.3167 -8809 4 34.9269 1.883 33.2395 6.71896 -7.58638 -28.1375 -8810 4 34.9733 0.615676 33.9226 0.339269 -19.4543 -11.259 -8811 6 50.9271 0.518298 17.9933 -4.01299 -8.33658 -1.61011 -8812 4 50.7551 1.39133 17.5891 -0.713529 -12.5397 8.99793 -8813 4 50.17 41.8323 17.8017 14.8721 13.6567 -6.57092 -8814 6 26.2328 30.5636 0.934374 -8.95911 39.2037 50.9017 -8815 4 26.9657 31.1139 1.27364 -12.5333 -13.1029 -5.86431 -8816 4 26.5352 30.0815 0.207089 19.4446 -20.9762 -37.1203 -8817 6 18.5681 38.3031 4.5613 16.0408 -0.4472 -12.493 -8818 4 17.6336 38.3732 4.40187 -16.7548 5.85511 1.82222 -8819 4 18.9561 38.7121 3.75593 -0.616515 -6.35836 15.3023 -8820 6 31.1349 5.07457 4.1166 35.5071 -12.4218 -11.0008 -8821 4 31.9258 4.61163 4.53765 -37.2933 13.7034 -13.5003 -8822 4 31.2792 5.02565 3.1391 -9.10044 -1.2591 17.9933 -8823 6 26.4378 21.892 1.49191 0.117022 -23.7737 9.75083 -8824 4 26.3504 22.7277 1.07049 4.38069 30.3527 -12.7348 -8825 4 27.3618 21.6023 1.50897 -0.762137 4.81239 -9.09803 -8826 6 39.2154 11.7026 22.7855 15.1366 1.14561 24.1899 -8827 4 39.8619 11.6546 23.5153 -3.42244 7.72178 -8.31759 -8828 4 38.7922 10.855 22.8508 -11.0077 -10.6036 -7.38167 -8829 6 13.6049 36.3215 30.6697 16.8779 70.0034 -37.8159 -8830 4 13.9417 37.1302 31.1268 -10.116 -30.1168 -5.71441 -8831 4 13.4922 35.6039 31.2515 -3.36872 -19.2676 30.0327 -8832 6 50.5831 9.86782 9.34675 -39.9446 -18.2052 0.719337 -8833 4 49.679 9.5553 9.65542 27.7691 6.62521 -8.8993 -8834 4 50.7343 10.6656 9.84378 7.47556 12.1458 9.31829 -8835 6 49.6659 40.3022 22.5839 -5.95569 -23.2057 2.00246 -8836 4 49.9088 39.3695 22.3976 1.04597 17.1639 -6.42107 -8837 4 49.3089 40.2511 23.4853 9.00681 3.37443 -0.55643 -8838 6 7.21026 41.318 28.8937 -13.882 28.5523 32.2899 -8839 4 7.13277 41.6426 29.851 5.74914 -19.7174 -37.6289 -8840 4 7.14599 0.215754 28.3517 11.7183 -8.26627 3.5395 -8841 6 13.0317 18.008 25.3351 57.1177 45.3919 41.6622 -8842 4 13.702 18.0765 24.6297 -18.9881 -2.87884 -2.05071 -8843 4 13.5608 18.5052 26.1022 -41.5403 -41.2906 -37.5185 -8844 6 50.0508 19.5822 2.43378 8.05757 -12.3534 -25.4868 -8845 4 50.6415 19.2321 1.70522 -9.91294 15.3245 28.3035 -8846 4 50.4964 20.3068 2.88656 9.48594 2.0046 -2.18375 -8847 6 28.3417 40.9623 24.5247 28.1527 -9.28969 -2.11238 -8848 4 28.8808 40.6229 23.7869 -8.53201 1.00989 5.926 -8849 4 27.851 41.6822 24.1702 -24.0642 17.3603 -12.6153 -8850 6 19.4173 5.36544 29.5282 -16.7292 -1.42659 17.4998 -8851 4 20.0576 6.03033 29.2802 12.6037 1.87093 -5.71578 -8852 4 18.8017 5.84191 30.1159 0.735032 -8.12986 -7.95209 -8853 6 35.3107 40.1454 22.2712 -2.40765 19.7984 -7.699 -8854 4 35.7006 39.9699 23.1142 6.54418 -16.9762 14.0951 -8855 4 35.2702 41.1078 22.294 -0.592679 0.794763 -5.20647 -8856 6 16.1889 33.7724 9.7458 10.3229 10.2088 29.582 -8857 4 15.8959 33.2543 9.01299 -6.07516 -13.8809 -16.7379 -8858 4 15.6715 34.5759 9.82028 -7.73583 2.776 -7.11592 -8859 6 17.3675 40.6445 20.2267 0.0256395 24.2963 -9.09373 -8860 4 17.2094 39.7816 20.6122 1.5629 -5.58702 6.23448 -8861 4 17.4758 41.3298 20.9152 1.51783 -13.2527 0.49298 -8862 6 20.5171 9.72867 9.58726 35.059 7.05341 -25.1666 -8863 4 21.2226 9.96362 10.213 -13.2653 -0.810893 -5.91795 -8864 4 19.8248 9.38464 10.113 -26.7953 -13.816 19.6743 -8865 6 47.4426 20.1922 21.3765 55.2231 -18.8128 34.629 -8866 4 48.295 19.6294 21.3384 -41.3243 22.9169 -3.74061 -8867 4 46.9816 20.0754 20.5659 -14.9725 -5.50706 -31.0177 -8868 6 38.4071 40.79 37.8146 12.3234 -22.6201 -9.80787 -8869 4 38.1404 41.7017 37.8605 -3.64711 23.1989 -4.06141 -8870 4 38.2696 40.4362 38.6954 -10.1247 -0.131598 9.15413 -8871 6 4.78578 1.94641 13.1038 0.280311 5.55092 -8.42179 -8872 4 4.79931 1.2475 12.4246 2.88607 5.75183 11.0778 -8873 4 4.58324 1.57529 13.9639 -2.31824 -10.9024 4.61034 -8874 6 46.8249 29.0091 2.16845 3.76482 2.94797 40.2579 -8875 4 46.7332 29.1215 3.14399 -15.0191 0.321828 -28.5005 -8876 4 47.6691 28.5689 2.15078 10.7116 -9.65214 -17.1948 -8877 6 37.4359 26.1653 25.6478 9.30824 1.4869 -5.75173 -8878 4 37.1837 25.5346 26.3178 -5.80587 -7.25577 3.90549 -8879 4 36.6384 26.5534 25.3025 -7.59782 4.42715 -0.0787482 -8880 6 27.3269 4.19583 19.442 5.96538 17.8772 -24.7701 -8881 4 28.0114 4.58146 18.8428 -3.77368 -14.8915 15.8068 -8882 4 26.5277 4.61529 19.0816 -6.14884 -6.84507 9.70558 -8883 6 29.57 35.1706 32.6629 9.65469 -19.4491 -13.9626 -8884 4 29.5306 34.4116 32.0191 -0.1659 24.8691 21.1709 -8885 4 30.4743 35.5004 32.5856 -0.51053 -0.290213 -2.43375 -8886 6 51.6097 27.3863 34.6091 -31.2455 30.913 9.06642 -8887 4 51.929 26.6019 35 16.42 -40.5282 7.55135 -8888 4 52.0725 27.582 33.8009 7.9649 -1.59603 -13.3915 -8889 6 26.2078 15.7281 22.6941 16.538 -21.7488 31.7554 -8890 4 25.9667 16.5615 22.3191 -8.70869 23.0893 -12.8942 -8891 4 26.0629 14.9994 22.0993 -9.54979 -3.97748 -17.7982 -8892 6 36.1239 41.1986 15.4707 -7.45359 -19.8962 -4.3143 -8893 4 35.6999 40.3419 15.2987 -9.47391 11.3121 -0.409552 -8894 4 37.0386 40.9374 15.4513 15.7433 3.85103 -0.545832 -8895 6 18.465 8.81345 11.2165 5.38391 10.0618 1.17025 -8896 4 18.7987 8.15135 11.8182 8.53154 -1.35082 11.1952 -8897 4 17.7161 8.38168 10.8393 -16.7411 -2.38381 -11.2186 -8898 6 30.2088 21.3096 23.2049 -11.6688 7.62645 -9.73036 -8899 4 29.9671 22.1993 22.9248 4.97058 -0.914249 3.78278 -8900 4 29.5299 20.7541 22.7893 7.94877 -1.13118 2.47612 -8901 6 22.73 2.20521 34.8374 1.74432 -25.8699 49.3747 -8902 4 22.3572 1.29354 34.8889 6.16039 22.5731 -10.8251 -8903 4 22.7018 2.4887 33.9486 -6.75325 10.5307 -40.1895 -8904 6 12.6909 2.75059 12.3422 -14.3125 16.3183 -13.6311 -8905 4 12.533 3.61796 11.8786 11.7453 -23.2619 14.9881 -8906 4 13.1336 2.19907 11.6816 1.83842 1.45343 3.2847 -8907 6 24.107 30.0639 14.5719 -73.5796 11.8292 4.65098 -8908 4 23.699 30.7611 15.1345 32.1371 -0.343623 -0.31889 -8909 4 23.2337 29.7156 14.2286 43.085 -3.68866 -7.89372 -8910 6 0.015177 27.9048 22.8533 -2.756 -4.53229 -2.63487 -8911 4 54.6492 28.3778 23.623 -8.36257 -3.01834 -6.1652 -8912 4 54.216 27.6514 22.3224 8.23112 8.70814 10.2495 -8913 6 12.3617 4.4844 25.9108 40.9735 -25.7794 -17.3291 -8914 4 12.201 5.40791 25.8162 -22.6464 21.2272 1.21762 -8915 4 11.6198 4.00067 26.267 -15.5784 4.93476 10.9426 -8916 6 50.6578 14.4652 5.91353 -13.9437 -6.30553 43.3918 -8917 4 51.4397 15.014 5.76935 2.55266 2.90763 -3.8133 -8918 4 50.4787 14.4827 6.92851 9.15248 3.54798 -49.9389 -8919 6 52.5668 22.873 20.1428 -12.6564 -29.9263 -28.8801 -8920 4 52.956 23.3393 20.8718 4.45243 13.9606 14.107 -8921 4 52.7899 23.3428 19.3246 -0.129831 10.341 11.583 -8922 6 43.5892 16.524 12.8775 29.595 -3.78245 -19.1347 -8923 4 44.3058 16.0087 12.3806 -28.6005 27.9094 23.6723 -8924 4 42.7982 16.4888 12.3437 -11.2315 -8.54457 -10.2035 -8925 6 15.9661 16.7487 40.5866 1.44034 32.7745 -1.20572 -8926 4 16.4126 17.3388 39.9207 -12.1014 -18.8104 17.452 -8927 4 15.5985 17.3766 41.2587 12.5036 -14.614 -16.5617 -8928 6 23.4158 18.8712 23.8473 -16.0774 -11.4939 3.2157 -8929 4 23.4518 19.2692 24.728 -0.157295 3.62127 -3.85719 -8930 4 22.4941 18.9757 23.5436 12.0607 -0.266031 2.57498 -8931 6 46.4178 3.27548 31.8952 19.5415 -1.29071 -17.2416 -8932 4 45.5866 3.26999 31.4067 -8.61336 -0.166695 4.01481 -8933 4 46.2657 3.3297 32.8359 -5.35267 1.32166 2.09612 -8934 6 43.4045 41.0584 12.2875 -8.04746 -23.5947 4.76735 -8935 4 43.6693 41.8276 12.7696 6.05224 12.9314 10.8988 -8936 4 43.5172 41.2728 11.3626 0.904796 3.93503 -13.2342 -8937 6 7.4976 32.4756 29.5884 -13.7893 55.6862 -12.0377 -8938 4 8.07142 31.7837 29.8334 27.4303 -26.9633 6.13269 -8939 4 8.04212 33.3166 29.512 -13.0153 -27.2422 -1.65156 -8940 6 4.77821 31.644 22.4997 2.28771 28.4048 16.4959 -8941 4 5.27411 32.2412 23.0928 2.56389 -13.4484 -8.63656 -8942 4 4.12057 32.2584 22.1518 -1.39427 -10.0394 -7.16978 -8943 6 48.879 26.8662 2.67919 -5.86075 -60.7959 24.9619 -8944 4 49.7001 26.7095 3.23946 -26.2991 7.4186 -32.0291 -8945 4 48.3448 25.9902 2.75892 28.4546 51.6452 -6.88552 -8946 6 35.3626 23.261 21.6242 -2.7789 -2.57103 6.54281 -8947 4 36.2261 22.8974 21.81 4.94258 -15.6751 6.88864 -8948 4 35.5426 23.9136 20.9639 -1.02428 17.548 -23.8062 -8949 6 9.79934 37.7758 27.3048 16.52 16.637 17.9603 -8950 4 9.72643 38.6113 27.803 -16.1555 -8.36248 -12.7831 -8951 4 10.5885 37.4189 27.7206 -2.15823 -16.4776 -5.60851 -8952 6 6.95685 10.9812 25.9821 -25.178 -21.2877 -4.97438 -8953 4 6.33357 10.2528 25.7268 23.179 21.9129 0.503821 -8954 4 7.29095 10.6974 26.8328 9.60603 -1.481 14.6966 -8955 6 15.9965 34.4888 38.9273 -2.91878 -3.91161 19.3063 -8956 4 16.0374 33.5463 38.7461 4.95306 -0.665665 -16.4822 -8957 4 15.9715 34.4958 39.9054 -7.59103 5.72172 -22.2107 -8958 6 24.1167 17.3197 36.1615 15.3363 -47.5124 0.380375 -8959 4 24.7173 17.5753 36.8648 1.58194 5.49031 12.5141 -8960 4 24.1546 16.3101 36.2205 -9.7187 30.8811 -7.11116 -8961 6 29.9757 19.0472 5.63639 12.788 -31.6225 11.2379 -8962 4 30.1584 18.5328 6.46799 -12.7316 12.501 -21.5451 -8963 4 29.4206 19.7916 5.84051 -11.4929 16.6696 15.0892 -8964 6 41.2293 14.2018 25.873 -1.75888 28.9255 -23.3251 -8965 4 41.1078 15.0995 25.4693 3.83492 -22.0907 13.098 -8966 4 41.2654 14.3268 26.8215 3.7207 5.50516 9.94654 -8967 6 30.6006 17.7874 37.3562 -24.7598 46.8721 10.074 -8968 4 30.0173 18.4181 36.8416 23.2796 -25.9316 -1.25214 -8969 4 30.633 18.2764 38.2118 8.15578 -14.795 -8.30511 -8970 6 36.2662 35.7599 28.8527 -12.8707 -30.9202 21.2821 -8971 4 36.6718 34.9534 29.2396 -10.1595 12.442 -4.1956 -8972 4 37.0218 36.2801 28.6478 17.3511 22.2532 -11.5483 -8973 6 0.195836 37.8645 20.3851 -23.6217 6.21569 -13.9532 -8974 4 0.549498 37.2778 21.0637 4.94615 -2.95215 -2.70832 -8975 4 54.3862 37.4234 20.0075 16.4722 8.11718 6.90773 -8976 6 49.5165 39.5896 25.2714 -0.622408 -34.3922 32.9891 -8977 4 49.1772 39.7667 26.1925 10.9208 -1.11318 -32.3029 -8978 4 49.8261 38.6352 25.2806 -10.9036 35.658 1.81375 -8979 6 21.6574 10.1952 29.3538 -5.06277 -0.743802 10.2318 -8980 4 21.4664 11.1105 29.223 -3.01111 19.5458 -20.3057 -8981 4 21.662 10.2064 30.3052 9.73006 -17.7161 13.8831 -8982 6 36.4636 30.0567 0.119709 9.37859 61.6807 38.5429 -8983 4 36.3123 29.4684 41.3206 -1.21017 -23.1836 -37.505 -8984 4 36.9143 30.908 41.7057 -13.4567 -39.5067 4.20368 -8985 6 35.2344 23.3726 39.1433 31.8417 -88.9919 -51.9106 -8986 4 35.0278 23.5012 38.2069 -5.96056 -5.38998 8.96032 -8987 4 34.9909 24.127 39.538 -31.8308 96.9265 45.0865 -8988 6 25.4761 17.6258 38.7257 1.29934 8.28965 -16.1346 -8989 4 26.2031 17.0769 39.0234 13.7946 -6.33455 1.86524 -8990 4 25.7107 18.4933 39.0598 1.3782 7.33891 4.86011 -8991 6 32.6846 1.71002 15.3734 -11.6254 -20.3205 21.5399 -8992 4 32.9453 1.93093 16.3086 -8.96834 -8.53877 -20.2534 -8993 4 32.154 0.853232 15.3925 19.204 32.1949 4.36426 -8994 6 2.7574 26.2382 40.1716 -4.40087 -21.6692 -50.7652 -8995 4 2.38718 26.7949 40.8139 -8.13358 26.7101 38.7547 -8996 4 3.41358 25.6429 40.5298 13.0891 -5.49009 7.80053 -8997 6 25.4307 39.5752 6.64887 -26.4755 -1.32722 14.1102 -8998 4 25.8932 39.0809 7.30961 27.038 -6.17916 -3.25304 -8999 4 24.5458 39.4465 7.03066 -2.44587 12.932 -21.9634 -9000 6 3.88975 2.45855 21.1879 28.3389 -91.355 -25.6726 -9001 4 3.44478 1.54109 20.9736 25.4092 48.4753 9.01111 -9002 4 3.19228 2.99847 21.4284 -47.2055 43.8768 12.3888 -9003 6 19.4353 35.9908 6.17834 -1.98144 -11.1023 18.0698 -9004 4 18.7425 35.7628 6.83514 2.39623 12.5316 -16.1317 -9005 4 19.0828 36.5127 5.45195 -11.0597 11.4176 1.1294 -9006 6 53.664 10.8386 34.7899 -0.427116 -3.27611 41.7292 -9007 4 53.6105 10.6836 35.7561 -1.66612 -17.5448 -26.7849 -9008 4 53.9652 11.7272 34.8329 4.68725 29.9217 -18.2793 -9009 6 51.2799 14.0867 34.6651 -29.2798 -10.9719 -23.3019 -9010 4 50.6522 13.5411 34.1107 26.8684 18.9114 5.01949 -9011 4 50.9895 13.8814 35.5479 1.81167 -5.08277 17.6681 -9012 6 14.4338 40.0198 28.0288 -0.147098 23.5255 27.6002 -9013 4 13.7688 39.3521 27.8218 1.28331 -8.25373 7.75106 -9014 4 14.1948 40.5222 28.8704 -0.878391 -19.6822 -29.209 -9015 6 36.0552 40.8569 1.29319 48.4065 13.1893 15.2608 -9016 4 35.4421 41.0883 1.96787 -21.4185 -0.412662 13.5205 -9017 4 36.896 41.2683 1.66088 -27.5471 -12.7345 -18.5843 -9018 6 32.5846 21.8706 9.62772 14.4951 6.80277 0.680584 -9019 4 32.1936 21.3098 8.97285 -7.2875 -23.9506 -7.81502 -9020 4 32.858 22.6104 9.08324 0.955029 10.0343 1.40437 -9021 6 53.7602 11.4574 10.0748 -7.70253 -4.89045 -17.0247 -9022 4 54.6558 11.7035 10.3272 3.70339 -10.2166 -5.16833 -9023 4 53.8328 10.8374 9.31644 -2.27357 5.83713 13.9933 -9024 6 25.443 2.0669 35.0212 -16.7533 17.7231 -21.4763 -9025 4 25.6415 2.91576 34.5502 -7.64634 -16.7974 11.4347 -9026 4 24.4652 2.09352 35.1703 17.3945 -2.11295 -4.26167 -9027 6 38.4088 16.3775 27.0777 23.4896 -26.556 7.92078 -9028 4 38.4029 15.905 27.9411 -0.72651 18.7119 -5.4255 -9029 4 38.1233 17.2789 27.1678 -4.67214 15.3602 11.0072 -9030 6 11.9834 11.8283 38.0863 1.50515 -20.9897 -19.5245 -9031 4 12.337 12.445 38.7318 -5.05033 4.06408 7.46746 -9032 4 11.0493 11.6049 38.244 7.06215 11.5652 6.68382 -9033 6 21.1646 40.7247 25.8949 30.8575 -6.32012 -20.5276 -9034 4 20.7152 41.4784 25.5554 -14.4662 20.9939 -18.0031 -9035 4 20.8194 40.6451 26.758 -13.9443 -15.9826 36.5019 -9036 6 5.45737 31.2526 28.1092 12.1805 15.5126 -2.48606 -9037 4 4.77986 31.7446 27.6301 0.776808 -0.764161 -8.53258 -9038 4 6.21204 31.8695 28.2031 -7.61365 -6.18966 7.74582 -9039 6 38.5666 10.4345 26.6322 12.4833 -8.23035 1.5222 -9040 4 39.2815 10.9281 26.2104 -2.91177 1.8082 -0.00903947 -9041 4 39.0293 9.89744 27.2937 -7.88948 5.75886 -1.98766 -9042 6 34.5704 22.2441 5.77364 -5.35359 -6.12765 6.5276 -9043 4 33.6261 22.329 6.01336 10.9983 8.59631 1.2651 -9044 4 35.1361 22.6291 6.46875 -10.1328 -5.43064 -4.61746 -9045 6 19.508 23.4157 8.91293 -5.78488 4.73981 5.04963 -9046 4 19.7274 23.1974 9.83518 1.16663 -6.94775 -9.92836 -9047 4 19.9131 22.8043 8.29809 9.12387 -6.1547 2.91491 -9048 6 19.7424 39.1606 18.9462 6.36032 12.2479 8.14591 -9049 4 20.3561 39.0422 19.6872 -3.85164 -4.35394 -5.20149 -9050 4 19.0738 39.7495 19.3414 -1.06489 -8.07777 -11.9442 -9051 6 19.0057 16.6591 37.8853 37.3334 -16.7993 4.17439 -9052 4 18.1861 16.4809 37.4823 -32.8062 -2.38488 -19.1553 -9053 4 18.8146 17.2984 38.5514 -2.10283 15.4454 14.1988 -9054 6 46.1541 18.3125 34.4675 -16.9871 7.29415 15.254 -9055 4 46.1595 17.7325 33.7168 0.615393 -10.1859 -17.2384 -9056 4 45.2376 18.6499 34.5058 9.28079 -5.03019 -2.85447 -9057 6 37.6537 4.93165 10.635 20.1552 -8.04423 -16.7256 -9058 4 38.5399 5.21744 10.272 -26.6503 -7.30776 7.98139 -9059 4 37.1074 4.55852 9.88971 22.9932 21.6332 27.1334 -9060 6 51.9792 36.004 6.8478 30.791 3.18545 -0.726681 -9061 4 52.2413 36.7963 6.35992 -14.9215 -4.55469 -2.53046 -9062 4 52.8266 35.8818 7.33626 -22.3254 6.63746 5.40006 -9063 6 26.6741 12.3268 1.0034 -10.7024 -25.4666 -34.2692 -9064 4 26.4988 12.3574 1.94138 -4.81655 1.43394 14.8604 -9065 4 26.0954 11.585 0.663483 16.9242 17.5219 15.4646 -9066 6 51.3423 35.7724 13.5298 -0.266216 29.5034 10.6004 -9067 4 51.4043 36.4131 12.804 2.34884 -4.4098 -1.45811 -9068 4 51.4073 34.9167 13.1542 5.41074 -27.2154 -15.541 -9069 6 1.98873 3.64285 24.5869 25.9971 69.8048 -55.2188 -9070 4 1.65752 3.03018 25.1632 -30.3002 -46.9535 54.3289 -9071 4 1.71436 4.54846 24.8879 2.6309 -26.2008 -0.982747 -9072 6 33.5221 15.2795 16.4506 0.0536135 -15.838 -38.1617 -9073 4 33.6476 15.3964 15.4593 -8.63578 3.82522 35.1416 -9074 4 33.7341 16.1085 16.8736 8.85342 14.4801 4.37501 -9075 6 10.7227 26.5775 37.3442 -67.903 54.2831 -20.645 -9076 4 10.2191 27.0779 38.0369 14.5194 -13.2702 -3.80745 -9077 4 11.4784 26.2608 37.7268 68.0232 -30.094 41.6962 -9078 6 39.6271 8.38119 31.999 1.44949 -5.13238 35.1009 -9079 4 39.1996 8.85287 32.7464 5.61163 -5.5592 -21.3265 -9080 4 39.0885 8.45634 31.2221 -15.3514 9.3045 -12.0182 -9081 6 48.873 24.2439 11.5987 1.10357 -37.2725 -9.21005 -9082 4 49.1825 23.3167 11.4023 -5.65288 27.9965 8.32055 -9083 4 49.5986 24.6511 12.0826 3.19491 3.15896 -2.50749 -9084 6 15.8098 8.51994 22.5326 -12.5814 0.672941 2.19285 -9085 4 15.7588 8.52265 21.5683 10.3815 2.49136 4.36748 -9086 4 15.4206 9.36801 22.7863 6.5895 4.65597 -0.371293 -9087 6 16.9392 23.5364 7.95083 25.1749 21.5498 -34.0775 -9088 4 17.2079 23.9031 7.093 -25.8979 -5.01679 3.50755 -9089 4 17.8126 23.4623 8.29573 16.7216 -7.09478 32.6865 -9090 6 42.4825 26.8555 6.33102 0.60087 7.54144 -12.7632 -9091 4 41.764 27.4892 6.46083 9.75026 1.01062 3.5184 -9092 4 43.14 27.3488 5.78659 -9.42643 -3.33158 7.6404 -9093 6 36.8078 4.79995 30.0438 -4.74249 18.2042 -3.85385 -9094 4 36.952 4.89746 30.9922 3.10706 -1.8894 0.559973 -9095 4 36.294 4.02131 29.8808 -10.4691 -15.4659 3.71438 -9096 6 45.6128 11.6142 3.31163 15.5246 21.1623 13.6733 -9097 4 45.8972 10.701 3.31117 0.727629 -14.3179 7.30305 -9098 4 46.2501 12.0834 3.90994 -13.3278 -10.7206 -15.6492 -9099 6 24.8943 36.3842 21.2731 0.145584 -0.0155718 21.9832 -9100 4 24.5073 36.3627 22.1568 -5.92138 3.86098 -2.91089 -9101 4 25.79 36.6624 21.4916 7.30899 1.2523 -13.3669 -9102 6 31.8172 24.7218 2.44079 24.9542 32.077 -0.738567 -9103 4 31.5948 23.8911 2.82575 -7.26237 -24.1795 3.52598 -9104 4 32.7966 24.7848 2.51706 -20.2581 -1.29655 -5.98664 -9105 6 24.135 21.9795 37.225 -18.6422 57.7065 19.5247 -9106 4 24.1223 22.9841 37.1061 1.06209 -41.2434 9.50937 -9107 4 24.7129 21.6948 36.5371 13.1815 -12.7877 -24.1492 -9108 6 37.1979 11.5342 15.06 20.8972 -17.7328 -40.5152 -9109 4 38.0246 11.7972 15.4709 -1.33045 5.21986 19.7962 -9110 4 36.429 11.9138 15.4438 -18.178 22.6449 25.793 -9111 6 36.4751 20.3399 41.7845 -26.5497 -48.0551 41.2862 -9112 4 36.3228 19.4621 41.3748 1.60744 11.8178 -3.29004 -9113 4 36.9246 20.873 41.191 27.5593 28.4699 -43.2619 -9114 6 32.0497 37.9214 32.6612 -32.2386 -8.50634 -18.7459 -9115 4 32.4337 38.7163 32.9803 20.8647 20.5609 12.2985 -9116 4 31.3654 38.2694 32.0613 5.31663 -14.2519 5.69849 -9117 6 12.0395 39.928 22.5123 -26.9832 36.7812 23.3187 -9118 4 12.2839 40.8414 22.1926 -3.01474 -29.6796 4.86816 -9119 4 11.2932 40.0883 23.1662 29.524 -10.585 -25.0576 -9120 6 26.3406 1.33526 19.2893 15.6729 -20.8034 13.8388 -9121 4 26.8411 0.655996 19.8199 -14.5491 24.9752 -14.9066 -9122 4 26.8003 2.1813 19.3861 0.112049 0.00336314 -1.02908 -9123 6 5.91669 14.3164 5.69097 2.29729 -16.5161 -30.3395 -9124 4 6.30102 14.1024 4.7902 -6.32478 5.25084 23.5077 -9125 4 5.06552 13.8494 5.70115 7.33482 -6.30923 1.55114 -9126 6 13.3703 23.089 19.1627 -28.3895 15.3871 14.4757 -9127 4 14.1086 22.8122 18.6632 27.2898 -8.01563 -16.6587 -9128 4 13.6991 23.742 19.8005 3.67942 -13.964 0.879599 -9129 6 23.4058 15.0688 9.73621 -4.11719 1.06855 12.2005 -9130 4 22.5732 14.661 10.02 0.657405 4.9462 -7.25364 -9131 4 23.2196 15.7347 9.05868 -5.70535 0.38861 -5.0655 -9132 6 49.5812 13.8288 18.4474 0.101153 1.0527 41.008 -9133 4 48.8214 13.4814 17.9923 -8.96247 -7.71084 -15.1851 -9134 4 50.2052 14.1722 17.8367 10.7879 13.5653 -33.2962 -9135 6 41.7444 5.67096 41.8915 25.5819 0.859229 17.1787 -9136 4 42.5704 5.9364 0.475256 -21.6624 -6.74737 -14.5764 -9137 4 42.0361 4.9893 41.2645 -5.04703 6.59959 -2.77397 -9138 6 17.2492 35.5437 2.55512 -4.98919 17.2489 6.23124 -9139 4 18.1963 35.629 2.41282 7.59523 -3.20753 1.41995 -9140 4 16.9663 34.6563 2.38439 4.57262 -16.6324 -5.73806 -9141 6 49.6936 19.8647 40.242 36.1149 -8.05295 1.41344 -9142 4 49.24 19.0314 40.466 10.1916 2.45634 3.62304 -9143 4 50.6901 19.7225 40.3055 -34.6505 -2.12616 -4.55887 -9144 6 38.3055 5.83107 32.0437 -25.1209 3.13983 17.5072 -9145 4 37.8566 6.51058 32.5952 5.57321 -12.5864 -8.78808 -9146 4 39.2068 6.11217 32.0045 20.6085 6.27671 -1.8315 -9147 6 16.2656 6.85278 34.0134 13.6308 -7.44031 -0.955967 -9148 4 16.5278 6.7006 33.1016 -0.686465 1.61317 -6.98637 -9149 4 17.0706 6.57794 34.496 -11.7464 5.49098 9.02554 -9150 6 33.6779 18.1919 10.4599 39.833 -25.9405 -6.08719 -9151 4 34.2274 18.843 9.984 -7.48822 -11.4027 6.26591 -9152 4 34.2403 17.3374 10.5556 -30.6671 44.9369 -7.76686 -9153 6 38.8896 33.7563 36.7672 22.7659 10.9801 -36.8997 -9154 4 38.4264 33.5452 35.9055 8.66825 7.19978 21.2858 -9155 4 39.8358 34.0039 36.5278 -27.7603 -15.0244 3.77145 -9156 6 45.3747 13.0912 20.2115 -8.54575 18.1695 38.2532 -9157 4 45.1986 12.6554 19.3957 -4.2418 -14.8759 -23.2281 -9158 4 44.5273 13.1029 20.6991 7.89471 -4.73094 -13.0554 -9159 6 36.3919 32.2126 8.83938 1.15121 -2.28434 -1.4136 -9160 4 36.3207 31.3933 9.34391 1.93757 3.36082 7.91897 -9161 4 36.0586 32.9456 9.38554 -3.10773 -8.06217 -4.51958 -9162 6 7.93399 27.8164 6.18652 -8.84441 8.26416 -30.5327 -9163 4 8.20753 27.2416 6.88401 9.15323 -7.03573 14.7081 -9164 4 8.30192 28.6748 6.41842 -5.04409 0.971707 0.751098 -9165 6 14.2889 4.87494 33.6812 -48.074 -5.72289 -27.637 -9166 4 13.5426 5.15568 33.0467 38.2298 -5.02982 23.8683 -9167 4 14.8103 5.65434 33.8518 10.0815 16.0504 2.39638 -9168 6 12.247 8.64363 9.86387 9.5307 8.47707 -42.9656 -9169 4 12.7265 8.83196 10.6522 4.83417 -1.95201 32.3898 -9170 4 11.3733 8.28369 10.003 -7.27928 -7.56138 14.4849 -9171 6 29.7193 31.982 8.5339 -11.3757 5.45371 -22.6092 -9172 4 30.2272 31.7973 9.28681 18.5431 -1.21859 37.4341 -9173 4 29.7513 31.1489 8.05875 -9.95983 -0.182644 -6.87416 -9174 6 22.3912 10.8818 21.4749 22.6973 -30.3469 0.856054 -9175 4 21.7953 11.1177 20.7819 -19.5872 13.8984 -18.5017 -9176 4 22.3568 11.5583 22.1363 -13.7305 16.7548 8.89642 -9177 6 54.1825 27.5382 12.9949 16.0749 -34.873 29.2784 -9178 4 0.169556 27.5337 13.075 -9.84187 5.32432 -2.29215 -9179 4 53.8855 28.25 12.4714 -3.97587 36.1158 -26.3516 -9180 6 7.7322 13.8127 20.037 -51.4252 10.19 -38.2554 -9181 4 8.32211 14.101 20.6974 26.6579 16.8549 28.1402 -9182 4 7.28001 14.6396 19.6917 19.816 -24.9044 7.79538 -9183 6 19.8038 0.841082 24.7751 2.23798 25.7663 18.7115 -9184 4 19.2888 0.974936 25.5977 -1.44078 2.26272 -14.328 -9185 4 20.345 1.66892 24.688 -12.1486 -28.8133 2.35345 -9186 6 3.00622 10.0987 2.94957 -26.3714 23.4248 -9.90714 -9187 4 2.57802 10.9845 2.80681 8.85648 -28.8297 5.38 -9188 4 3.90714 10.2978 3.18407 20.8138 3.7803 5.2 -9189 6 15.8735 13.0135 24.0167 27.3456 -6.4848 -7.35342 -9190 4 15.0397 13.4574 24.067 -14.2007 12.8972 1.61729 -9191 4 16.3075 13.2711 24.8409 -0.511489 -7.63656 -0.0548578 -9192 6 17.0843 4.34635 26.9246 21.6007 -4.50946 14.2865 -9193 4 16.8972 4.2188 26.0046 2.50265 0.324122 -20.691 -9194 4 18.0611 4.2338 26.9976 -18.2314 5.96709 -0.11875 -9195 6 33.6189 39.4094 10.6341 -20.462 51.0085 -28.6484 -9196 4 33.9391 38.663 11.0702 20.9333 -51.253 8.17882 -9197 4 33.8334 39.409 9.67256 -1.15733 -4.02232 18.0774 -9198 6 36.2391 1.10544 13.1071 -14.4853 9.25302 -40.2412 -9199 4 35.5849 0.422507 13.2928 -0.138393 -8.38057 10.5121 -9200 4 36.8138 1.26142 13.8363 9.41155 -3.27129 23.8008 -9201 6 40.853 19.2974 5.10856 37.2457 -28.9827 71.4026 -9202 4 40.5429 19.587 4.3016 -40.6732 16.7295 -57.0845 -9203 4 40.1307 19.0416 5.7147 0.644924 10.2678 -10.4268 -9204 6 2.34714 37.5568 10.1845 35.9634 7.02123 17.8242 -9205 4 3.04769 37.1203 10.7322 -14.847 6.26565 -12.1612 -9206 4 1.86424 36.8893 9.71962 -14.8151 -24.6966 -11.8987 -9207 6 8.10127 29.0413 15.8656 35.302 -29.7249 12.8686 -9208 4 9.00843 28.6191 15.9508 -31.5464 15.4715 -14.0583 -9209 4 8.16404 29.7921 16.4466 -1.11054 13.1495 4.82257 -9210 6 47.3142 26.5199 12.5393 12.6514 34.6971 -22.5506 -9211 4 47.5805 27.2834 11.915 -17.373 -39.4708 28.4474 -9212 4 47.3752 25.7188 12.0092 -0.907674 -0.00416251 -5.94845 -9213 6 33.5917 17.5154 0.659811 -43.6991 -50.8046 22.4668 -9214 4 32.6165 17.4611 0.916402 33.9721 22.4374 -10.1482 -9215 4 33.8023 16.5556 0.790839 15.7196 25.0769 -8.55135 -9216 6 38.9785 15.6005 36.3846 -2.2974 -5.19358 -9.56289 -9217 4 39.1604 14.6481 36.4599 -0.972636 7.263 -3.41001 -9218 4 39.314 15.9159 35.5329 5.29716 -3.31476 -2.44888 -9219 6 34.8185 34.3512 9.36223 6.47638 -43.1481 -28.0847 -9220 4 35.4473 34.9875 9.0418 9.26483 22.2324 -9.2882 -9221 4 34.4241 34.6992 10.1221 -17.9819 29.7233 40.2724 -9222 6 44.963 2.56985 14.7807 31.4374 15.1132 5.36654 -9223 4 44.0324 2.49792 14.9225 -24.9873 -3.38313 6.1219 -9224 4 45.264 3.39221 15.2058 -8.16761 -2.00961 -7.57881 -9225 6 42.6004 38.2794 19.8329 35.0217 22.8895 -33.2683 -9226 4 42.7468 39.1886 19.4383 -9.39889 -30.5105 9.50416 -9227 4 43.174 37.7101 19.2395 -23.2435 10.9907 19.5876 -9228 6 18.6884 26.768 30.2631 -44.5574 -6.69712 -17.565 -9229 4 18.1049 26.7773 29.4546 19.8507 -1.43152 25.0232 -9230 4 19.5658 26.9377 29.9555 24.8572 5.14496 -8.76909 -9231 6 38.8622 37.7231 16.4658 -22.8479 4.5656 13.1257 -9232 4 38.7902 36.7734 16.2818 1.44729 8.74588 -1.32739 -9233 4 39.7766 37.9619 16.5567 26.2519 -3.67716 3.06508 -9234 6 49.2941 9.82087 12.5338 42.2108 35.2088 45.7943 -9235 4 48.9089 9.29765 11.888 -36.0338 -29.0733 -40.4243 -9236 4 48.6148 10.195 13.1058 -6.01968 0.395602 -5.44143 -9237 6 43.2224 7.37144 19.82 -8.13737 3.26926 23.5272 -9238 4 42.5007 7.77471 20.3735 21.5488 -7.79487 -11.5807 -9239 4 44.0862 7.49788 20.2643 -6.92785 0.102081 -4.68832 -9240 6 36.344 38.7219 4.42923 6.60518 -8.27287 -3.54737 -9241 4 36.8681 39.515 4.62823 -9.591 -1.38231 4.53716 -9242 4 35.4251 38.8858 4.67742 1.90858 4.69501 2.45497 -9243 6 27.7906 17.7903 15.1063 3.75124 -7.8529 -14.6222 -9244 4 27.6041 16.8818 14.7764 0.112743 20.8749 5.00331 -9245 4 27.89 17.7299 16.0573 -1.67078 -3.69001 6.73869 -9246 6 18.0934 3.7697 37.3166 -37.4896 -7.94699 -19.9181 -9247 4 18.6099 3.0373 36.9676 7.8944 1.98274 4.30106 -9248 4 18.6508 4.23334 37.9126 25.9725 10.5984 22.5053 -9249 6 7.70643 11.5866 6.5218 3.89219 -35.3855 26.5153 -9250 4 7.81247 12.3986 6.99593 -0.830342 19.7116 4.35361 -9251 4 7.69429 11.7375 5.59555 -1.18048 8.56411 -33.1609 -9252 6 31.493 14.3493 18.0362 -8.33789 -14.4781 24.6772 -9253 4 32.1359 14.6991 17.4236 11.1505 2.18599 -11.6706 -9254 4 31.9992 13.8221 18.6877 -1.72215 8.99473 -5.41338 -9255 6 50.3257 30.4119 8.91981 13.6638 2.66477 0.921327 -9256 4 49.6699 30.7962 8.33415 -6.09837 5.9585 -1.44957 -9257 4 50.0726 29.5063 9.09532 -3.6785 -2.74239 1.52637 -9258 6 42.1666 10.1001 12.7665 27.8846 0.568566 -7.78474 -9259 4 41.2574 9.89168 12.6212 -25.0269 -7.71108 -1.23548 -9260 4 42.2044 10.927 13.2385 -4.76175 6.29789 8.61568 -9261 6 37.7726 3.10257 32.5651 17.7286 -33.908 -11.3576 -9262 4 38.1655 3.96622 32.6549 -5.80606 19.6252 0.391082 -9263 4 36.8286 3.11418 32.7073 -14.5698 15.7581 5.48125 -9264 6 35.7529 13.1025 19.269 15.6222 -22.7979 5.95892 -9265 4 36.108 13.8438 19.7616 3.89933 6.86159 4.70877 -9266 4 36.3275 12.3403 19.5267 -16.9537 12.3267 -5.61016 -9267 6 45.5307 4.12701 21.4866 3.53751 -14.4086 10.8893 -9268 4 45.552 4.15257 20.5178 1.20389 1.85135 1.62688 -9269 4 45.7304 3.20168 21.7391 -1.66454 15.9633 -13.005 -9270 6 16.8818 1.84763 31.4809 -38.7514 34.7723 -17.791 -9271 4 16.1373 2.3559 31.0688 16.7124 -32.2776 -3.52377 -9272 4 16.9707 2.38347 32.2636 22.4894 -8.71684 18.7287 -9273 6 14.088 4.88632 23.5804 12.6338 -46.5447 -4.7054 -9274 4 13.8705 5.7909 23.7155 -14.7558 31.001 11.1078 -9275 4 13.7332 4.31383 24.2952 -4.17517 18.1368 -8.36436 -9276 6 38.3179 33.7515 12.3711 -25.6361 -5.15185 -28.4625 -9277 4 38.1256 32.9508 11.8227 6.04426 17.9062 13.2724 -9278 4 39.1779 33.654 12.756 21.0695 -5.21903 12.1581 -9279 6 35.6902 3.04562 37.6746 -3.39904 8.35156 -7.25132 -9280 4 35.0929 2.54933 38.2324 -5.1037 -10.0227 3.00486 -9281 4 35.8394 3.86187 38.1597 5.81883 9.20211 1.39187 -9282 6 31.3375 37.3986 35.3773 -3.71028 -11.6357 31.0668 -9283 4 32.2621 37.6229 35.4422 12.7398 8.80293 9.59752 -9284 4 31.1956 37.5429 34.4696 -8.56261 0.879722 -41.7472 -9285 6 52.0699 11.7425 14.0188 13.7235 -2.71131 -30.9774 -9286 4 51.8967 11.0942 13.2788 12.7756 18.36 20.3091 -9287 4 52.777 12.3878 13.7226 -29.9657 -23.6346 9.26958 -9288 6 26.3494 3.44143 41.0133 25.155 -37.875 16.6614 -9289 4 25.5593 3.94137 41.1232 -17.1598 23.2709 -17.7277 -9290 4 26.8278 3.58917 40.1822 -8.59815 12.7626 -4.44352 -9291 6 24.371 34.9599 11.1571 26.4033 32.6711 -2.50587 -9292 4 24.3639 34.5741 12.011 0.42503 -6.32387 38.1824 -9293 4 23.9976 34.2869 10.6415 -25.866 -31.4028 -29.8537 -9294 6 32.0031 7.59722 31.2247 -0.72006 7.33901 18.8157 -9295 4 32.1508 7.36357 30.327 0.345644 0.817488 -27.7554 -9296 4 31.6126 8.48818 31.2118 -2.13527 -8.40442 2.30992 -9297 6 28.7291 2.6069 0.424694 -24.9548 -1.7826 -18.2237 -9298 4 29.2265 2.34055 41.548 2.55638 3.32464 9.52498 -9299 4 27.7798 2.59721 0.142899 25.7986 3.33204 9.63582 -9300 6 42.1267 19.2107 9.86358 19.9254 -1.00598 31.807 -9301 4 42.7282 19.2504 10.675 -28.0191 -3.63038 -32.4782 -9302 4 41.4654 18.506 9.99331 2.41107 5.70909 -2.24499 -9303 6 33.0117 27.0899 8.33041 6.96541 -9.8522 -22.9567 -9304 4 33.8754 26.9804 7.88875 -4.89246 2.6856 6.68054 -9305 4 33.1889 27.2976 9.23992 7.88062 7.04275 14.0068 -9306 6 4.17016 8.31297 19.162 0.312608 -23.727 -31.8356 -9307 4 4.57057 7.90515 18.3575 7.98956 13.418 22.158 -9308 4 3.24181 8.25888 18.9046 -6.31749 7.79174 9.16769 -9309 6 20.797 29.1851 37.0682 -78.8245 -16.0462 -5.4556 -9310 4 20.936 28.2326 36.9784 16.4861 -0.723813 3.66436 -9311 4 21.5674 29.6886 37.0761 54.0195 18.5923 4.39527 -9312 6 13.113 4.99943 10.9253 0.843453 12.9862 -7.21248 -9313 4 13.3812 5.91092 11.1622 0.48683 -16.0572 0.936043 -9314 4 12.7752 5.03128 10.0238 -4.21215 6.55392 -0.64752 -9315 6 37.5015 18.1018 32.5195 21.2703 25.6519 14.9603 -9316 4 38.1786 18.7738 32.2234 -25.3038 -17.5123 8.13315 -9317 4 37.1867 18.4103 33.3985 6.70568 -0.056708 -13.7279 -9318 6 17.7491 33.2689 30.7387 4.64458 14.8517 -20.1826 -9319 4 17.8421 33.9996 30.1068 1.39741 -2.79987 6.34018 -9320 4 18.5541 33.2627 31.2599 6.50121 5.74528 2.59283 -9321 6 23.1871 32.777 9.90494 7.13269 10.4795 -4.3903 -9322 4 23.4604 31.94 10.2921 1.41378 -5.3263 0.807867 -9323 4 22.2339 32.7251 9.74224 0.938735 -0.283076 -0.953242 -9324 6 14.8916 9.36878 34.2544 -3.17606 -9.25219 -4.09189 -9325 4 15.4257 8.57154 34.1751 4.23415 -4.52565 -0.814207 -9326 4 15.1936 9.94604 33.5417 3.33837 13.7034 4.88209 -9327 6 31.123 39.3556 38.5725 10.4581 -15.7875 9.507 -9328 4 31.6408 38.6334 39.0195 -17.0405 19.4438 -10.5616 -9329 4 30.3963 38.9123 38.1137 2.26745 0.847431 0.999129 -9330 6 5.28935 34.441 28.2777 -1.85934 -10.7383 -20.8922 -9331 4 5.27738 35.3973 28.3959 -1.64374 -0.931958 4.82044 -9332 4 5.15855 34.3195 27.3212 3.56171 0.206479 13.9304 -9333 6 30.3161 21.6889 14.1169 -2.08187 28.5408 26.4102 -9334 4 30.4824 20.7856 14.3415 3.20532 -20.0191 -7.60805 -9335 4 30.3589 21.8902 13.1869 1.55029 -10.1196 -17.5522 -9336 6 23.85 39.0046 28.2977 69.4329 26.2515 4.57453 -9337 4 23.9916 39.6084 27.5499 -13.57 2.08121 2.63988 -9338 4 23.036 38.5875 28.2612 -60.5143 -23.8938 -11.8576 -9339 6 9.59742 13.5396 16.4589 33.261 19.9292 -8.86772 -9340 4 8.78625 13.0496 16.3926 -14.9619 -4.96746 -5.567 -9341 4 9.78335 13.9533 15.5888 -9.09133 -14.4247 9.50074 -9342 6 25.9705 6.17968 15.7985 42.799 -23.1477 28.9675 -9343 4 26.019 6.01901 14.8637 -2.75181 4.35539 -17.3872 -9344 4 26.7603 5.64791 16.135 -36.9143 25.7793 -10.0513 -9345 6 15.9952 33.6108 22.5498 -1.32684 21.179 0.174096 -9346 4 16.0845 34.132 21.7265 -5.08009 -17.3545 9.33233 -9347 4 16.0452 32.6693 22.2946 2.44519 21.8582 -2.86748 -9348 6 40.6954 13.5457 12.1293 -5.68603 3.79069 10.9638 -9349 4 40.3939 13.0592 11.3555 -1.07855 -14.0058 -3.54454 -9350 4 41.0539 12.9031 12.7626 -3.06611 3.62129 -5.67307 -9351 6 35.5822 40.2773 31.6862 -1.2862 -13.706 14.6905 -9352 4 36.0451 40.9783 31.2154 -1.32327 -4.34646 -14.1397 -9353 4 35.653 39.3915 31.2603 0.648621 22.1552 -3.29488 -9354 6 19.3539 17.5757 17.8527 24.8545 64.4629 -5.36553 -9355 4 19.9703 18.4106 17.9379 -31.776 -45.1138 0.798127 -9356 4 18.7059 17.8424 17.1823 2.41282 -7.28307 3.58563 -9357 6 7.95249 28.0742 10.7793 26.3782 25.043 4.49745 -9358 4 8.50313 28.8396 11.0908 -15.1612 -19.5627 1.83511 -9359 4 7.20779 28.4792 10.322 -5.34026 -2.34355 -4.06419 -9360 6 32.1473 39.5951 16.6478 -17.9563 1.55165 -8.91142 -9361 4 31.6569 40.3908 16.3404 14.2892 -12.9666 6.03874 -9362 4 31.5266 38.8716 16.4637 6.06753 4.48602 8.64925 -9363 6 35.7883 2.63292 18.1275 9.48574 -34.9606 14.0071 -9364 4 34.8666 2.32593 18.1793 13.7366 6.70894 -2.41967 -9365 4 35.7792 3.51083 17.8116 -6.62646 29.9084 -15.3578 -9366 6 14.9404 39.9496 36.887 -3.95865 -34.2615 35.0372 -9367 4 15.4649 39.4425 36.2826 11.0028 -6.45738 -16.6057 -9368 4 15.0284 40.8419 36.6608 5.56286 51.7396 -15.8162 -9369 6 18.3052 32.4025 11.469 7.68428 8.43447 19.219 -9370 4 18.6311 32.5236 12.4045 -8.3236 -1.07971 -30.5152 -9371 4 17.8613 33.2392 11.223 7.02035 -14.738 0.639166 -9372 6 14.6021 10.381 5.00501 12.904 -5.64335 9.41677 -9373 4 13.6938 10.4305 4.69945 -10.3065 0.63937 1.1744 -9374 4 14.613 10.0418 5.92181 -1.23128 6.20644 -15.3767 -9375 6 2.02771 14.3355 39.1727 -5.84559 30.0988 4.34298 -9376 4 2.70173 15.0418 39.0898 -4.78946 -14.8923 5.30178 -9377 4 1.28797 14.7602 39.6738 10.0694 -17.377 -15.1558 -9378 6 7.58332 14.1556 32.4652 3.8824 27.7869 10.7592 -9379 4 6.9433 13.665 32.9756 -4.43494 -6.18284 1.69377 -9380 4 7.54129 15.0698 32.8492 6.23928 -24.1467 -15.6449 -9381 6 6.15722 23.1341 37.6504 -34.5618 -50.1938 -2.0692 -9382 4 6.56488 23.96 37.7745 13.4151 41.4847 -0.267706 -9383 4 5.38195 23.2242 37.0516 20.9526 5.02196 8.70483 -9384 6 37.2952 22.537 4.44472 51.3933 75.9823 3.75371 -9385 4 36.5074 22.1342 4.18978 -47.7056 -22.8011 -17.3868 -9386 4 37.221 23.5361 4.21623 -3.53185 -51.7458 12.1203 -9387 6 47.1368 31.0168 5.89375 -14.3926 17.1884 -69.1718 -9388 4 46.9718 30.7968 6.77028 -10.6218 -7.91998 56.0799 -9389 4 46.2684 31.351 5.53353 23.0456 -16.9797 4.17914 -9390 6 54.8109 25.5937 34.9376 16.0179 27.3393 -6.0446 -9391 4 54.0726 25.4665 35.5517 -1.08617 7.29827 -2.61058 -9392 4 0.161491 26.54 35.0366 -21.9365 -36.0956 3.57937 -9393 6 37.1499 2.07739 4.80452 -1.94348 22.0087 -45.3652 -9394 4 36.668 2.89852 4.54683 5.06511 -19.4283 11.9563 -9395 4 37.1062 1.96831 5.73813 -4.74438 -1.19387 27.2393 -9396 6 22.5142 28.609 8.91066 14.7838 -0.767913 33.3492 -9397 4 22.9803 28.3541 9.73828 -15.565 12.7605 -7.61321 -9398 4 22.8168 27.9481 8.31925 3.93055 -13.9923 -25.0246 -9399 6 8.64284 27.1533 24.5627 -30.3364 66.7798 9.61681 -9400 4 7.68564 27.0552 24.6389 4.16714 -15.7471 -5.05425 -9401 4 9.10482 26.3676 24.4825 22.9633 -64.4218 -6.53839 -9402 6 1.14841 23.7276 2.43845 3.37143 2.75553 -28.3576 -9403 4 1.24451 23.8913 1.47114 -2.40676 3.6179 20.3541 -9404 4 0.297784 23.2877 2.48462 -2.13531 -2.42607 6.29474 -9405 6 54.3749 30.2279 27.0351 -1.87188 5.01086 -25.6864 -9406 4 54.247 29.4439 26.4851 0.283672 1.58093 2.67322 -9407 4 54.589 30.9178 26.3677 -1.31459 -2.18642 16.2549 -9408 6 0.382292 8.43516 23.9819 16.8945 -11.9539 9.7221 -9409 4 1.32445 8.60369 24.1565 -2.20413 -11.2301 -8.89161 -9410 4 54.9553 8.73001 24.7921 -9.77823 11.7559 2.768 -9411 6 16.9131 28.5848 33.3683 -2.23593 -25.3201 -21.0962 -9412 4 17.3654 28.7863 34.1955 9.02781 -2.88055 -0.915496 -9413 4 17.3951 27.8627 32.8656 -13.2947 27.9561 26.4245 -9414 6 33.6945 30.8881 0.140848 11.5734 5.16226 7.65985 -9415 4 34.5903 30.4955 0.196618 -6.50407 7.83028 -3.90982 -9416 4 33.2725 30.4522 41.313 0.902851 -8.5209 -4.03004 -9417 6 16.2572 21.5133 34.1618 -1.32279 -12.2579 -0.0768877 -9418 4 15.8666 20.7686 33.6578 14.5936 10.7995 5.0381 -9419 4 16.7742 21.1109 34.8905 -13.5083 8.43335 -11.1581 -9420 6 0.208862 17.804 35.7536 -14.601 -29.9007 -2.72034 -9421 4 54.2286 17.807 35.5323 33.4083 9.0609 14.8615 -9422 4 0.362977 16.9429 36.1939 -0.60553 13.4006 -6.21859 -9423 6 16.8205 12.2987 0.018055 22.2965 10.2312 29.8095 -9424 4 17.2696 12.8062 0.753963 -11.4311 -8.71934 -28.0399 -9425 4 16.617 11.4478 0.422257 -11.1364 1.3302 -4.58262 -9426 6 8.24969 9.53941 36.253 -15.0171 13.8578 -6.15226 -9427 4 7.92627 8.96163 36.9484 -10.0154 -4.61382 -0.313479 -9428 4 7.46687 9.9886 35.83 14.4541 -3.15884 14.1629 -9429 6 48.5699 26.7153 39.8372 -6.05787 -6.72914 15.0837 -9430 4 48.3449 26.8926 38.9385 -16.4424 3.29077 -18.6566 -9431 4 49.4571 27.0352 39.8842 23.4859 3.73228 5.76721 -9432 6 35.4844 1.07048 23.1169 11.4549 30.8088 37.1655 -9433 4 36.0158 1.76714 22.6808 -9.17201 -14.7916 0.90361 -9434 4 35.6328 1.27141 24.1103 0.373025 -19.0496 -44.6811 -9435 6 20.2784 30.6315 19.3752 23.9103 -21.6662 15.3888 -9436 4 20.3116 31.0532 20.259 -5.42732 -3.95571 -8.57186 -9437 4 20.9344 29.8759 19.4191 -22.0709 25.9102 -5.54449 -9438 6 44.3706 15.9499 1.58551 5.68582 14.4456 12.9619 -9439 4 44.3685 15.5676 2.49167 2.87795 14.7015 -16.764 -9440 4 44.6274 16.9163 1.6094 -6.5628 -31.3198 6.45039 -9441 6 53.8881 34.4681 10.5864 -33.0496 11.7448 -26.9592 -9442 4 54.422 34.2751 11.3149 32.4161 -9.35278 40.7994 -9443 4 54.2788 35.2396 10.1584 -0.0979649 -6.0993 2.73708 -9444 6 46.1388 32.8516 33.5211 5.22207 -15.0187 3.22626 -9445 4 45.9452 33.6327 33.0044 -1.75723 11.2428 -3.91525 -9446 4 47.0422 32.5752 33.2841 -5.1447 4.42718 0.252344 -9447 6 42.1248 21.9061 24.225 29.3467 -8.59285 14.1471 -9448 4 43.0897 21.6191 24.2618 -39.2895 4.06832 7.69751 -9449 4 41.7308 21.6944 25.1042 13.707 1.91177 -18.5137 -9450 6 8.13464 3.90485 11.6471 19.3767 -1.70453 -18.8264 -9451 4 7.33962 4.19894 12.0861 -8.05938 -6.79837 10.6821 -9452 4 8.35918 3.01511 11.9412 -4.68297 1.80025 9.46807 -9453 6 19.6422 41.6776 9.83213 -10.6455 12.1827 13.5714 -9454 4 18.8651 41.1405 9.66265 4.99962 -3.76564 -7.41899 -9455 4 19.3487 0.264237 10.6212 9.02518 -11.5641 -14.6522 -9456 6 42.3073 8.42404 31.6799 28.9247 6.2763 -10.2166 -9457 4 41.4386 8.38933 32.0551 -18.7028 2.48038 0.978172 -9458 4 42.5266 9.37939 31.5704 -3.99861 -19.3235 1.7837 -9459 6 26.9144 16.155 25.3557 3.37886 4.46922 -29.1574 -9460 4 26.8932 15.8089 24.4276 -4.09623 14.1183 21.5023 -9461 4 26.5944 15.4425 25.8888 -2.2842 -17.5105 15.3426 -9462 6 48.2339 6.48607 12.6213 -2.32796 -4.32122 -9.13051 -9463 4 48.9884 6.29985 12.0375 -6.36801 1.93824 2.64233 -9464 4 47.4521 6.15437 12.1363 8.14441 0.739204 7.03502 -9465 6 53.4551 41.5313 30.6545 -6.55363 -20.9747 -16.7061 -9466 4 53.9707 41.8328 29.895 1.38615 3.54438 2.31965 -9467 4 53.5938 0.199493 31.3858 11.9182 14.0856 15.8016 -9468 6 47.0766 22.4304 31.8083 3.49024 11.2606 -9.33253 -9469 4 47.8957 22.458 31.249 -27.0486 7.80914 13.6686 -9470 4 46.5597 23.2507 31.6033 14.3992 -20.3875 6.89099 -9471 6 19.5103 5.43818 15.252 80.4346 7.77941 -36.259 -9472 4 19.9845 4.58151 15.2093 -6.94904 10.3389 3.32724 -9473 4 18.6939 5.26573 15.6196 -64.0069 -9.45641 27.6942 -9474 6 14.6723 30.2358 33.3977 29.3194 14.0021 -15.573 -9475 4 15.2147 30.9127 32.9173 -16.9191 -15.4944 5.99358 -9476 4 15.2716 29.4658 33.3729 -9.39086 7.05787 2.01807 -9477 6 28.44 24.2314 10.4028 3.15123 -12.4056 -9.54268 -9478 4 29.226 24.4262 10.8786 32.4584 2.85658 2.79411 -9479 4 27.8296 24.5485 11.0342 -36.3144 6.15546 12.0187 -9480 6 5.27118 14.4387 24.4945 35.1445 25.2092 -0.0633509 -9481 4 4.43594 14.1516 24.7736 -48.8682 -19.2375 4.52664 -9482 4 5.4685 14.0235 23.6561 -3.04719 -11.4521 -9.99341 -9483 6 26.3524 19.2908 19.1818 20.1263 -20.0506 -24.4735 -9484 4 26.6388 20.1349 19.5116 -1.98461 18.5008 5.62334 -9485 4 27.0961 18.9592 18.5977 -26.1102 9.18548 27.2368 -9486 6 28.5758 7.44193 13.1857 16.8206 36.5977 2.40675 -9487 4 28.4276 6.5743 12.8854 -8.83608 -34.241 -6.14436 -9488 4 29.1296 7.84613 12.4994 -7.23682 2.38597 3.89632 -9489 6 5.36882 27.1473 37.046 11.8823 -4.88323 19.1587 -9490 4 6.08575 26.9595 37.7076 -19.1456 -1.45009 -21.6041 -9491 4 5.36685 28.0942 36.8598 5.86896 -0.355799 -4.60773 -9492 6 53.1378 13.4025 16.0996 34.2435 -3.86055 5.06914 -9493 4 54.0829 13.0966 15.9504 -32.0077 5.91706 2.7318 -9494 4 52.5847 12.6783 16.4422 5.4814 -0.344951 -11.4066 -9495 6 45.452 1.01889 24.6154 3.31322 11.7394 9.54943 -9496 4 44.8157 0.989703 23.8982 -3.33354 -4.25493 -1.52857 -9497 4 44.9019 0.844105 25.4008 9.82267 -2.51687 -6.81685 -9498 6 50.1641 2.37547 13.9256 -5.79196 7.9049 4.59273 -9499 4 50.7992 2.78767 13.3238 -3.84891 -0.754592 0.637936 -9500 4 49.4746 3.0334 14.0873 2.34893 4.7321 -2.13859 -9501 6 19.5803 31.0161 39.1628 -18.0613 -25.9328 -11.5794 -9502 4 19.7424 30.2951 38.4816 -0.347779 24.7736 22.083 -9503 4 18.6224 30.9377 39.4182 28.2801 4.19594 -11.375 -9504 6 19.2561 14.7051 10.8744 35.9018 -50.5273 5.13524 -9505 4 20.0412 14.097 10.5737 -45.0165 49.548 5.48727 -9506 4 18.7602 14.0269 11.3662 -4.16951 16.5755 -2.6658 -9507 6 4.45594 39.5485 20.1375 -7.26247 21.8372 28.3356 -9508 4 3.95576 40.4005 20.2782 15.6699 -22.2203 -5.74536 -9509 4 4.87483 39.3065 21.0019 -15.4768 4.14169 -24.4646 -9510 6 29.0152 13.3442 23.91 8.01267 35.4951 15.4816 -9511 4 28.7225 12.4574 23.7464 -4.82052 -12.6612 5.31893 -9512 4 28.8407 13.5397 24.8723 9.679 -4.85246 -32.6651 -9513 6 17.068 2.76349 17.6602 17.5731 -10.7754 -19.6116 -9514 4 16.9152 3.43747 16.9733 0.569879 -2.90947 3.06519 -9515 4 17.8166 2.20316 17.3149 -21.6663 12.1671 7.12297 -9516 6 43.4725 18.0406 17.7144 -1.44781 -24.3706 15.3127 -9517 4 43.4291 17.0524 17.7495 6.1749 24.1268 -14.107 -9518 4 43.576 18.2305 18.6573 0.474252 7.4982 -2.94392 -9519 6 25.7765 40.7491 1.25834 -5.13784 -8.67992 -41.8469 -9520 4 26.3241 41.1434 1.92597 2.9618 17.1891 5.50682 -9521 4 25.7331 41.3641 0.469204 -4.81559 -13.5206 29.0343 -9522 6 0.465549 22.8917 6.22214 -2.55797 -7.94984 -3.9446 -9523 4 0.971697 22.1453 5.8424 -8.20264 3.34524 4.91565 -9524 4 1.09943 23.372 6.75946 4.60597 5.6548 -4.31438 -9525 6 26.241 35.011 18.6432 -1.36099 17.7753 -9.20742 -9526 4 25.9471 35.9461 18.6768 6.76043 -15.7179 -8.96745 -9527 4 25.6107 34.5957 19.2286 4.79325 -10.2415 3.05652 -9528 6 16.134 31.8742 7.55305 63.3701 -24.5537 -22.1036 -9529 4 16.96 31.3344 7.22221 -43.8871 18.402 28.1533 -9530 4 16.2567 32.6659 7.02685 -6.92396 6.43503 -6.66113 -9531 6 22.9365 16.8424 28.5556 -11.8911 28.7995 -6.03551 -9532 4 23.1131 16.1224 27.957 -2.92592 -13.6094 -7.1053 -9533 4 22.1672 17.3806 28.2048 22.5292 -24.3034 15.5849 -9534 6 48.8154 29.3426 32.1508 17.6607 -5.63259 25.101 -9535 4 47.9338 29.1776 31.8283 -15.752 -0.354552 -3.67809 -9536 4 48.876 28.9209 33.0523 -3.3832 13.4569 -22.7771 -9537 6 13.1275 24.861 5.55911 -24.9858 12.0714 -24.023 -9538 4 12.9095 24.1076 4.98414 3.68764 2.77663 3.09454 -9539 4 12.4428 25.5491 5.3163 19.4298 -17.0083 16.84 -9540 6 10.97 20.7168 15.838 25.2219 -21.2413 -18.4662 -9541 4 10.9273 20.4774 14.8836 -9.78471 10.8905 20.232 -9542 4 11.8407 20.3068 16.0784 -25.4832 11.5027 -0.03881 -9543 6 13.8668 18.3675 6.9377 -17.1805 34.1284 -15.5183 -9544 4 13.9861 19.3268 7.07801 0.95534 -8.68107 -9.41428 -9545 4 14.2312 17.9937 7.71618 14.696 -22.4056 21.3209 -9546 6 13.8328 12.9436 30.6366 23.8936 8.4875 1.93436 -9547 4 14.0561 12.5213 29.7889 -15.7862 -10.4805 9.2002 -9548 4 13.0857 12.5134 31.0734 -5.46762 -5.09599 -12.1481 -9549 6 17.1276 6.33232 31.2677 66.6528 76.8842 26.6004 -9550 4 16.7194 7.19542 31.0916 2.25558 -4.54354 -1.53399 -9551 4 16.4872 5.75051 31.0533 -74.7845 -70.3194 -26.0669 -9552 6 7.63688 23.4278 20.549 2.87884 3.81634 -6.68902 -9553 4 7.34623 23.1229 19.6666 2.94756 -0.449201 10.6329 -9554 4 8.04096 24.3016 20.3852 -3.87648 -11.4978 -1.95405 -9555 6 15.5875 36.6622 25.6317 44.8659 35.0544 -6.16252 -9556 4 16.5723 36.6215 25.7443 -25.3852 -14.6967 7.558 -9557 4 15.5456 37.5452 25.2115 -8.92727 -11.7797 -1.50769 -9558 6 0.738994 10.4213 22.1809 -27.1543 -36.2471 -13.1925 -9559 4 0.031346 10.3136 21.4752 22.4259 7.4169 21.1377 -9560 4 0.614162 9.62536 22.7539 0.837437 23.266 -16.3015 -9561 6 33.4753 17.3986 33.5966 50.0322 34.9653 -25.691 -9562 4 33.729 18.3684 33.3861 -23.79 -42.9591 12.1009 -9563 4 34.1104 16.8695 33.0603 -9.99519 5.32569 13.787 -9564 6 21.6594 19.0069 20.7632 22.9673 -17.6764 -6.78691 -9565 4 22.3468 19.6741 20.9606 -3.94962 -13.1079 -1.95693 -9566 4 22.1476 18.14 20.6003 -16.6978 33.0759 6.74927 -9567 6 41.7633 20.003 16.8748 -11.326 -1.31128 -8.84591 -9568 4 42.2034 19.1563 16.9874 6.48398 -7.2756 0.328325 -9569 4 41.4682 20.0367 15.9399 8.87316 5.12137 10.7952 -9570 6 12.0358 14.9766 17.6999 -26.21 -7.2152 -26.0517 -9571 4 11.2991 14.5498 17.1995 11.2858 13.8526 14.1879 -9572 4 12.4764 14.2447 18.105 9.10187 -13.3837 13.9354 -9573 6 23.0147 11.4211 40.7142 -19.9953 11.3897 74.5259 -9574 4 22.9359 12.2968 41.1901 4.60696 -23.5555 -21.1396 -9575 4 23.3157 11.5565 39.857 19.7433 14.0142 -51.5111 -9576 6 21.0056 28.3023 24.5803 -69.1041 85.2373 -40.9106 -9577 4 20.265 28.1264 25.1705 5.37048 -3.26467 3.49678 -9578 4 21.6928 27.7549 24.7451 59.1792 -66.0576 27.8401 -9579 6 19.39 13.7159 31.9239 29.4118 -13.0288 15.1298 -9580 4 18.7661 13.9847 31.2678 -13.3276 3.02657 -9.68553 -9581 4 18.8827 13.5849 32.728 -3.24577 4.6437 7.00982 -9582 6 21.5915 2.84466 24.7134 0.208747 24.5944 -29.04 -9583 4 21.6872 3.18692 23.7998 -4.92058 -5.74628 13.5023 -9584 4 22.4885 2.58061 24.905 3.18231 -12.543 15.1704 -9585 6 11.3458 29.9955 18.8336 12.03 22.8495 18.6886 -9586 4 10.5716 30.5896 18.8018 6.29595 -15.7791 -4.99952 -9587 4 11.9743 30.476 19.4324 -17.0963 -23.9187 -22.0967 -9588 6 14.6495 22.3648 8.3568 42.8177 1.00499 7.23029 -9589 4 14.0031 23.0587 8.53935 2.83958 6.20927 5.13977 -9590 4 15.5993 22.7606 8.33857 -60.0645 -13.0658 0.526795 -9591 6 43.9468 23.6541 17.2812 -2.43742 26.8438 -12.7514 -9592 4 44.7651 23.2701 16.9945 19.1668 -3.91001 -9.18188 -9593 4 43.5028 22.9 17.6346 -11.2125 -8.13016 15.2757 -9594 6 28.0047 25.4978 27.5091 9.49546 -35.4414 -7.32855 -9595 4 27.536 26.3032 27.53 -22.6173 33.7003 2.08289 -9596 4 28.9082 25.7508 27.3241 10.2254 5.98924 0.98151 -9597 6 19.1021 26.8113 33.1456 6.96794 1.44941 -44.6281 -9598 4 19.0009 26.3889 32.2316 6.61058 22.4795 36.193 -9599 4 19.4537 27.7357 32.9996 -8.5054 -25.835 6.12407 -9600 6 6.37601 19.3499 5.67113 -3.07724 -15.511 8.20386 -9601 4 6.68786 20.0294 5.07731 7.18653 8.65774 -7.7972 -9602 4 5.56195 19.7092 6.03854 -2.87224 2.62267 4.46635 -9603 6 37.49 28.403 9.68405 -10.2736 -31.6176 -26.4717 -9604 4 37.8518 27.9475 10.4351 5.1765 10.0485 19.5132 -9605 4 37.3493 27.6251 9.09625 -2.69325 25.3221 7.01666 -9606 6 17.6998 27.0953 11.7898 -36.7906 -34.4972 13.5582 -9607 4 17.0141 26.488 11.3694 25.6316 27.0728 3.78529 -9608 4 17.4298 27.07 12.7376 6.94557 14.4563 -18.9236 -9609 6 12.8888 1.93962 24.1529 -50.3802 38.9184 -15.728 -9610 4 12.0235 2.45928 24.1313 32.0413 -19.6529 -17.3906 -9611 4 12.9222 1.7892 25.0724 13.055 -19.4335 33.1456 -9612 6 27.8476 37.1183 33.3015 17.2618 -5.56645 -20.6455 -9613 4 27.8725 37.7306 32.5366 -3.66202 -8.07766 15.1749 -9614 4 28.4268 36.3488 33.0405 -13.8477 22.6944 8.61763 -9615 6 18.6736 12.3707 6.31908 6.91225 -31.4632 27.4828 -9616 4 18.6995 11.385 6.25383 -9.67628 20.7874 -2.26223 -9617 4 18.5836 12.6888 5.4344 -4.12511 6.2973 -26.1687 -9618 6 10.1784 29.305 24.7735 -9.10204 -23.9111 21.4033 -9619 4 10.6991 28.9855 25.5395 2.35147 16.2142 -6.30056 -9620 4 9.48939 28.598 24.7147 15.6456 22.7499 -9.47694 -9621 6 7.25796 3.28933 16.2737 -3.06701 21.6066 -7.53298 -9622 4 7.8017 4.02386 16.6541 -5.18893 -18.6288 5.77884 -9623 4 6.83195 2.7267 16.9458 19.6595 6.39335 -0.783342 -9624 6 32.1965 37.5589 1.11244 17.7564 -13.393 -49.4834 -9625 4 31.8113 36.9118 1.6863 -14.8068 -2.94474 23.9511 -9626 4 32.3136 38.4192 1.49585 -8.3749 16.0852 25.1081 -9627 6 10.4319 10.1504 6.4166 -7.63199 8.14139 10.6713 -9628 4 9.50403 10.3698 6.52583 -9.38347 6.87647 -8.77798 -9629 4 10.8186 10.5343 7.22249 5.92406 -9.68277 -8.25616 -9630 6 16.1813 23.2506 37.3799 25.1097 11.6639 -4.85114 -9631 4 16.5396 23.4181 38.2693 -7.5274 5.30939 -3.10176 -9632 4 16.7237 23.8262 36.781 -18.6662 -9.83464 11.0165 -9633 6 24.0859 14.3313 36.5421 -9.86516 7.30801 -0.382215 -9634 4 25.0278 14.1902 36.5644 12.4097 -8.07045 3.76472 -9635 4 23.7255 13.9571 37.3615 2.98939 6.5027 1.55174 -9636 6 27.4763 18.5532 28.7891 -13.5271 -4.91773 7.22809 -9637 4 27.279 18.1935 29.6763 -0.617381 3.48163 -16.8994 -9638 4 26.6639 18.4733 28.2428 3.34183 3.33207 10.806 -9639 6 51.5601 10.4909 1.56577 -57.9967 -14.5533 -18.7957 -9640 4 50.8004 9.99697 1.98849 19.2905 21.9947 -18.6033 -9641 4 52.233 10.462 2.20044 35.6887 -2.31897 35.1783 -9642 6 31.1159 39.6224 27.5035 10.1927 26.9633 6.19817 -9643 4 30.6636 39.3812 28.2975 -12.6206 -22.2416 8.82104 -9644 4 31.2642 40.5609 27.7597 6.49383 -23.2522 -24.0775 -9645 6 6.91312 35.9708 14.3252 -31.0555 -15.8542 22.3873 -9646 4 7.60399 36.2341 13.7609 26.7748 16.1612 -20.4248 -9647 4 7.14109 35.0698 14.5861 -2.88708 -0.858877 1.78829 -9648 6 45.5543 7.568 29.1737 -25.5302 -4.16762 -2.13202 -9649 4 44.8976 7.53234 28.4293 19.2773 0.699039 20.3251 -9650 4 45.0852 7.16669 29.9393 6.23602 2.26061 -10.7804 -9651 6 31.3622 20.562 31.6184 9.65463 4.63597 0.319717 -9652 4 31.8498 21.4034 31.7895 1.14978 -23.5084 -11.6884 -9653 4 31.8627 19.9392 31.0494 0.180852 16.2895 10.8054 -9654 6 43.0328 31.1512 10.3804 -22.1718 15.2565 33.5805 -9655 4 42.075 30.8844 10.4741 26.7443 4.92622 -3.29861 -9656 4 43.2631 31.5811 11.2548 -4.68507 -19.1463 -31.4268 -9657 6 50.935 25.5526 12.6381 -53.0362 -11.2381 37.5759 -9658 4 50.8444 26.3707 12.1889 6.26198 32.0523 -21.5557 -9659 4 51.7606 25.1556 12.4927 46.8244 -9.35474 -8.90879 -9660 6 29.329 2.97736 3.64421 22.5456 -43.1143 -6.52899 -9661 4 29.5843 3.84773 3.82541 15.3974 46.6652 11.4603 -9662 4 28.3975 3.01514 3.57252 -35.3193 1.84796 -10.7817 -9663 6 53.9306 32.0952 20.3602 -26.044 3.42844 6.98601 -9664 4 54.8587 32.2554 20.2589 13.6369 -3.90514 -8.57062 -9665 4 53.586 31.7345 19.5218 3.48091 2.50952 8.05406 -9666 6 41.7156 29.5544 6.48768 19.5894 27.0766 -19.1548 -9667 4 40.8143 29.536 6.19581 -21.1406 0.0261655 0.681639 -9668 4 42.121 30.2839 5.93213 -7.9284 -21.0777 21.5612 -9669 6 37.8354 24.5725 39.3073 -0.786614 -2.83003 -8.48557 -9670 4 37.3057 24.1981 38.5867 -0.305281 2.91934 11.1175 -9671 4 37.4479 24.2715 40.1417 -1.64355 1.86967 -5.36783 -9672 6 46.558 27.5785 23.289 -39.9634 -64.6481 11.0379 -9673 4 46.4646 27.3918 24.2576 6.74558 16.0433 -18.2165 -9674 4 45.9199 26.8188 22.9475 37.5572 46.869 6.09964 -9675 6 9.22773 27.2022 8.33468 -36.26 12.7871 28.7267 -9676 4 8.91275 27.6129 9.1801 5.62558 -9.89589 -23.2096 -9677 4 10.1414 27.0456 8.46037 35.2783 -3.07459 2.5747 -9678 6 36.0491 34.1608 13.9867 7.26402 -14.0442 8.68546 -9679 4 35.9913 33.1738 14.0461 -7.39622 22.1346 -4.41017 -9680 4 36.7548 34.3393 13.3524 -0.0889916 -4.95725 -2.25698 -9681 6 51.6742 14.4867 12.321 25.1613 25.5512 -24.4042 -9682 4 52.0989 14.4284 11.4335 -6.19684 -3.38259 22.4379 -9683 4 51.9807 15.3554 12.6493 -12.3863 -19.4348 1.31199 -9684 6 15.2583 19.6409 32.4144 29.0083 -20.2623 -33.8133 -9685 4 15.2558 19.2688 31.4922 3.04968 7.12699 22.6875 -9686 4 14.3622 19.8256 32.5802 -41.1763 4.86179 8.56209 -9687 6 27.6812 24.6569 38.3606 -19.0318 -31.8029 -32.3422 -9688 4 27.9736 25.1472 39.0974 14.6808 26.4307 29.745 -9689 4 28.3717 24.6185 37.6939 9.13491 6.22605 4.36089 -9690 6 37.5205 9.26898 13.6241 11.458 -4.07639 -2.41324 -9691 4 37.986 8.73412 14.2818 -4.17908 -1.66932 4.91722 -9692 4 37.422 10.1332 14.0472 -5.80925 -1.58022 -1.38856 -9693 6 20.8962 33.2419 26.2614 5.37543 12.855 -2.41316 -9694 4 21.3204 33.4412 27.1125 -5.30181 -3.15861 -4.46659 -9695 4 20.9369 32.3076 26.1263 8.87353 -20.0108 1.20924 -9696 6 6.59104 13.9455 35.2329 -26.8274 -4.60486 4.58094 -9697 4 6.38745 12.9897 35.2457 11.7642 5.99643 -3.17645 -9698 4 7.53507 14.0926 35.2395 12.5421 -8.77428 2.26249 -9699 6 10.0726 7.48467 6.8792 2.12641 6.95589 -11.9404 -9700 4 9.21804 7.15917 6.5645 -4.80657 -1.75614 5.47812 -9701 4 10.1222 8.42177 6.5916 5.16955 -15.159 7.51812 -9702 6 31.1977 5.95154 11.4339 24.7603 28.3677 15.6689 -9703 4 31.4296 6.16733 12.4018 -4.97657 -8.97631 -41.3224 -9704 4 31.9131 6.32779 10.8565 -11.9651 -11.6794 24.5691 -9705 6 12.1328 3.85103 35.2933 -10.0815 -12.0493 27.5499 -9706 4 12.7851 4.21657 34.7189 20.4312 8.87509 -12.0205 -9707 4 12.5123 3.89786 36.1903 -2.36263 6.36147 -16.6701 -9708 6 5.35168 6.07805 27.6549 3.96089 -18.0524 46.6648 -9709 4 5.01336 6.85569 28.0965 2.16186 8.49085 15.9688 -9710 4 5.1377 6.25223 26.7855 -7.5711 11.2001 -66.4514 -9711 6 13.1382 33.574 1.68419 20.6109 34.6607 2.95503 -9712 4 12.5953 33.0967 1.0817 -13.6453 -8.09858 -18.4215 -9713 4 13.3822 34.4502 1.26439 -11.0211 -27.5174 16.1165 -9714 6 44.6427 10.3996 29.0359 8.91116 23.4714 -13.18 -9715 4 44.4953 9.45294 29.0952 0.434286 -4.87704 -7.20081 -9716 4 44.1618 10.7755 28.2587 -0.00111917 -13.6507 16.636 -9717 6 9.15295 24.5944 6.37753 4.35763 15.0755 22.3214 -9718 4 8.87327 24.2546 5.53613 0.42871 5.14079 -20.2862 -9719 4 9.64462 25.4438 6.24707 -3.48643 -17.4971 -5.55606 -9720 6 52.5676 27.2719 21.6547 -2.39965 -30.061 -11.5856 -9721 4 52.5233 26.307 21.7841 0.332471 11.3908 13.792 -9722 4 52.7558 27.2791 20.7178 5.02488 16.4903 -8.77251 -9723 6 7.3066 16.9604 33.5537 -1.04195 2.49046 -7.43677 -9724 4 7.33543 17.7138 32.943 1.81348 -0.803559 0.920864 -9725 4 6.38938 16.6816 33.595 -7.62852 -0.129201 -7.36731 -9726 6 43.922 25.2186 7.97522 -0.776236 -10.551 19.3716 -9727 4 43.2647 24.8119 8.58447 10.2741 2.86697 -16.6436 -9728 4 43.4353 25.9147 7.53069 -5.46224 6.25576 -5.43654 -9729 6 2.0869 27.1165 13.6049 -6.62274 17.6596 -9.16822 -9730 4 2.19606 26.2295 13.9488 0.235583 -10.4047 3.43352 -9731 4 2.56841 27.1544 12.7597 2.10867 -4.70259 8.20201 -9732 6 37.3318 18.2771 2.1863 -11.4974 3.81579 3.71073 -9733 4 37.5653 17.6745 1.47223 -1.7687 -9.97531 1.83125 -9734 4 36.746 18.9091 1.7765 -5.93566 5.03593 -3.95155 -9735 6 24.9999 10.057 0.434977 -12.0635 -2.74649 0.799886 -9736 4 24.3308 10.4048 41.7106 3.78591 -9.33137 12.164 -9737 4 24.5954 9.37599 1.02184 5.69483 17.6459 -16.041 -ITEM: TIMESTEP -10 -ITEM: NUMBER OF ATOMS -9737 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 5.4990000000000002e+01 -0.0000000000000000e+00 4.1909999999999997e+01 -0.0000000000000000e+00 4.1909999999999997e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 9.97007 5.59928 0.0158605 6.82717 25.1566 0.173859 -2 2 9.62356 5.56404 40.5109 2.42388 15.8202 -17.9785 -3 2 8.17494 6.05177 40.4142 55.7411 37.9916 -4.02595 -4 3 7.24177 5.30408 40.552 -31.6102 -16.3698 1.50252 -5 4 9.18703 5.26911 0.576869 6.09491 -0.0281501 2.37507 -6 4 10.258 6.55078 0.333037 -13.6694 -25.1619 -9.93433 -7 4 10.7495 5.00053 0.227298 4.73684 -5.2578 1.97242 -8 4 10.3453 6.24708 39.9044 -16.4644 -11.4072 20.4818 -9 2 9.76873 4.13927 39.9675 -11.4588 -40.6165 34.779 -10 2 9.50273 3.78744 38.4932 15.666 28.6261 8.68394 -11 5 10.1133 2.12508 38.0108 0.295651 13.5297 3.11239 -12 2 9.21855 1.10832 39.2168 14.7368 7.58368 -1.20954 -13 4 9.08721 3.4839 40.6484 10.5431 15.7462 -21.5186 -14 4 10.7894 3.80905 40.2705 3.27862 -1.66199 -9.78219 -15 4 9.96352 4.6291 37.9056 6.4614 -19.967 -0.497951 -16 4 8.45197 3.92389 38.2658 -20.9649 -8.28542 -1.62155 -17 4 9.45855 1.42591 40.2577 0.123087 -4.74543 -3.47868 -18 4 9.48787 0.0601841 39.0477 5.23249 -11.9374 1.58081 -19 4 8.1518 1.18086 39.043 -21.148 5.31153 -2.14239 -20 1 8.09229 7.41048 40.3029 -14.2332 10.7223 -5.89196 -21 2 6.79937 8.10304 40.1889 5.24089 -19.8495 27.4218 -22 2 6.18195 7.49232 38.9365 0.114954 6.75236 -38.7125 -23 3 6.7427 7.67352 37.8124 -12.8129 -5.94191 21.2876 -24 4 8.91546 8.03754 40.1502 -4.33809 -15.705 2.93584 -25 4 6.18636 7.83053 41.1247 8.71228 4.86543 -21.2479 -26 2 7.05427 9.64124 40.1755 -39.1485 4.05492 14.7867 -27 2 5.78354 10.5475 40.1236 1.30256 17.7056 10.1762 -28 2 4.88546 10.5193 38.8862 -3.79578 -25.0164 33.8013 -29 3 5.09523 11.2746 37.9701 4.75276 20.2207 -26.2166 -30 1 3.8145 9.69296 38.9578 -10.6259 3.8922 -22.0733 -31 4 7.59986 9.93872 39.279 22.1314 0.316188 -7.87442 -32 4 7.59095 9.90263 41.1476 2.09094 2.02455 -19.3111 -33 4 6.10317 11.6308 40.2015 3.5236 -15.0099 -9.27626 -34 4 5.16114 10.4864 41.0336 -3.30627 -13.4665 3.57605 -35 4 3.54863 9.07856 39.7488 8.69916 3.95403 -0.745788 -36 4 3.18874 9.68238 38.1158 12.5738 1.24403 17.0425 -37 1 5.02604 6.79083 39.0278 7.4524 -0.797845 -45.9123 -38 2 4.17847 6.29332 37.9221 -3.7942 -15.2224 -3.95324 -39 2 2.69747 6.67222 38.2029 32.4064 16.6491 21.8024 -40 3 2.47317 7.27763 39.2627 -13.9875 -5.03172 -5.20453 -41 4 4.49693 6.75941 39.8611 -16.5463 3.77927 46.4214 -42 4 4.45927 6.7815 36.9606 1.68834 7.22657 1.16434 -43 2 4.32357 4.73766 37.6872 -14.444 16.6417 -7.09057 -44 2 3.62009 3.87951 38.7772 14.6644 -34.8859 1.43809 -45 2 5.79989 4.34797 37.5209 14.6689 -37.6664 -23.8861 -46 2 3.73665 2.34984 38.4383 -15.0607 27.3941 -9.62179 -47 4 3.8042 4.58537 36.6865 5.44811 -8.07725 9.84866 -48 4 2.54132 4.09064 38.8487 -7.82462 7.38089 1.0406 -49 4 4.05844 4.00808 39.8052 -1.99007 7.91776 -7.51683 -50 4 6.34139 4.39198 38.494 2.7915 9.59572 -3.8015 -51 4 6.26587 4.94741 36.6895 -0.816692 -0.0793993 15.4171 -52 4 5.96503 3.2496 37.1567 -11.5696 29.092 9.48874 -53 4 3.39623 2.18998 37.357 4.41378 -5.40883 18.8177 -54 4 3.12239 1.76276 39.1489 -5.35757 -4.6989 -2.16583 -55 4 4.76682 2.00075 38.5743 10.6291 -5.64517 -2.52342 -56 1 1.71265 6.3536 37.3575 -33.5913 -12.5481 -9.77554 -57 2 0.284755 6.62158 37.6816 12.6554 33.7668 -4.20076 -58 2 54.3822 5.43344 37.3699 -27.7691 3.87457 8.29319 -59 3 54.7838 4.49252 36.6867 3.01204 -3.04336 -3.37779 -60 4 1.82497 5.72672 36.5372 4.10411 3.68048 5.38879 -61 4 0.194803 6.88576 38.7694 2.48378 -12.979 2.09758 -62 2 54.7189 7.90551 36.9466 -7.72609 -12.13 5.61678 -63 2 0.656639 9.069 36.6919 -2.01357 8.03554 13.9604 -64 2 1.52683 9.2194 35.5966 7.55435 5.75852 -14.6577 -65 2 0.515029 10.1503 37.577 28.0972 23.5099 -14.6501 -66 2 2.25128 10.4257 35.3726 -4.96866 -39.5758 -10.6477 -67 2 1.27413 11.3326 37.3973 2.53894 16.486 1.64204 -68 2 2.1477 11.4375 36.2812 10.2448 65.1187 39.3263 -69 4 53.8018 8.25583 37.5371 13.1335 -2.90056 -11.9634 -70 4 54.3208 7.62968 35.9579 -2.73912 -6.0948 -8.85904 -71 4 1.62786 8.40831 34.848 -1.08621 1.70246 3.68663 -72 4 54.8519 10.113 38.4282 -15.3846 -1.92761 17.9785 -73 4 2.932 10.5406 34.5118 -0.192368 -3.19302 0.526177 -74 4 1.1987 12.2443 38.1226 0.692592 -32.2473 -20.0357 -75 4 2.79857 12.4271 36.2097 -23.9561 -41.0367 -3.09354 -76 1 53.0712 5.5328 37.7893 -5.57771 32.7805 23.2413 -77 2 51.973 4.62909 37.5111 5.69369 -27.8287 -42.174 -78 2 50.7933 5.44178 36.9635 6.83138 2.9595 14.8019 -79 3 50.2601 6.28483 37.7029 -2.00888 -3.43203 -15.9694 -80 4 52.7232 6.34215 38.4237 19.8206 -30.3225 -23.0649 -81 4 52.294 3.8899 36.6472 -5.7065 17.91 27.0613 -82 2 51.558 3.79481 38.7755 -4.51595 7.33433 1.21121 -83 2 50.3828 2.83682 38.5018 -9.13901 -44.4412 -29.5986 -84 2 52.8166 3.00155 39.2294 -15.7012 -7.04664 11.9409 -85 4 51.1774 4.47766 39.5861 12.1653 -0.853429 -2.8896 -86 4 50.5215 2.15128 37.5875 8.57056 17.9281 16.1392 -87 4 49.4053 3.30815 38.2892 0.50336 12.9055 3.57196 -88 4 50.1645 2.10956 39.3273 7.20165 10.7054 2.61524 -89 4 53.3305 3.56036 40.0335 2.85201 1.25263 3.90533 -90 4 53.556 2.88446 38.4204 4.77396 -6.45058 -3.13498 -91 4 52.5519 1.98529 39.6413 5.25091 8.27159 -2.68354 -92 1 50.4114 5.20625 35.6841 -20.1476 8.87025 -3.50293 -93 2 49.1688 5.73971 35.0966 -28.9774 8.99335 -1.66554 -94 2 48.0726 4.67952 35.3573 13.5632 -27.7837 -20.7653 -95 3 48.2724 3.51151 34.9309 -12.9152 20.0019 12.3092 -96 4 50.758 4.377 35.1895 1.67728 -2.63512 -1.50997 -97 4 48.8371 6.69602 35.5973 10.748 -7.18216 5.66994 -98 2 49.2038 6.04752 33.5367 10.0422 21.5226 29.5984 -99 2 47.9776 6.84135 32.9981 5.60977 17.6728 -19.5296 -100 2 48.06 7.31101 31.4919 41.3779 8.51018 8.58065 -101 2 48.2223 6.22581 30.3803 10.2277 10.7815 -8.37061 -102 1 48.1882 6.76889 29.0124 -44.0668 -20.3552 -6.98541 -103 4 49.2392 5.11894 32.9842 10.5057 -23.1259 -12.3022 -104 4 50.1653 6.62923 33.3927 -11.345 -5.02104 -10.4632 -105 4 47.825 7.77207 33.6051 2.48464 -5.23088 2.05035 -106 4 47.0343 6.2773 33.0942 -1.95432 -7.79908 6.21428 -107 4 48.9189 8.07819 31.4105 -13.7973 -19.6161 -0.159439 -108 4 47.1832 7.92091 31.2683 -17.7289 5.61577 -2.96622 -109 4 47.3306 5.536 30.4593 16.0468 -5.76301 1.4082 -110 4 49.2642 5.74618 30.4425 -24.8663 -4.45667 9.08666 -111 4 48.9827 7.28362 28.7526 29.3958 17.558 -6.10605 -112 4 47.3901 7.43056 28.8463 17.4375 -26.0151 1.0329 -113 4 48.1308 5.99149 28.2967 -4.23626 26.2635 18.8845 -114 1 46.923 5.03715 35.9679 -17.5656 23.7329 15.0201 -115 2 45.6707 4.26397 36.0383 7.41887 0.1342 36.2715 -116 2 44.9083 4.3955 34.7419 -9.99807 18.7078 -56.0122 -117 3 45.3082 5.1515 33.8118 -11.5681 -21.3087 27.1246 -118 4 46.8218 5.98238 36.4144 8.23522 -16.4135 -11.8728 -119 4 45.8989 3.17264 36.1884 2.80321 2.94058 -5.13324 -120 2 44.7401 4.70263 37.2808 -1.60464 -36.3649 -20.2774 -121 3 44.4616 6.07663 37.208 27.8602 32.4116 16.0792 -122 2 45.244 4.25605 38.6868 21.6281 49.2853 -20.5016 -123 4 43.7497 4.17807 37.1099 13.0537 7.54308 5.65065 -124 4 45.2592 6.57873 37.5303 -28.9412 -17.1189 -11.5145 -125 4 45.9129 5.11546 39.1089 -19.7485 -23.953 -1.10378 -126 4 45.8752 3.36487 38.6536 3.71139 -12.8851 -1.61893 -127 4 44.3595 4.03827 39.3021 -3.33201 1.23649 16.0156 -128 1 43.7613 3.66416 34.5997 13.2589 -16.0433 44.4251 -129 2 42.7828 3.62815 33.5465 18.9204 -1.21878 -42.6601 -130 2 41.7763 4.78741 33.7016 8.26701 -3.22526 52.4496 -131 3 41.2647 5.35582 32.7525 -2.05798 3.57411 -28.7638 -132 4 43.4932 3.04471 35.4154 4.99312 14.665 -20.8764 -133 4 43.36 3.79542 32.5266 -17.2288 -0.741434 30.8189 -134 2 42.0901 2.2209 33.4572 -3.06831 -30.079 -8.91003 -135 2 42.9343 0.899345 33.7586 6.86735 -2.69949 -8.81151 -136 2 42.2038 41.463 33.3849 1.50493 16.9918 14.9247 -137 2 44.2499 0.864187 32.9361 47.2855 12.5868 41.6398 -138 4 41.5678 2.05281 32.481 6.79941 12.0418 -2.16148 -139 4 41.2531 2.16469 34.1657 -6.29243 10.0771 8.19014 -140 4 43.198 0.869694 34.8519 -1.4112 0.953999 -4.44245 -141 4 42.8702 40.5903 33.6002 -4.10478 0.398246 -9.68788 -142 4 41.7896 41.4589 32.3582 7.27854 -3.68783 -7.38435 -143 4 41.3262 41.3063 34.0224 -6.75638 1.39507 6.42691 -144 4 44.0947 0.829251 31.8728 -5.75954 4.64229 -28.5029 -145 4 44.9396 41.8855 33.1737 -20.9549 12.1515 -1.19165 -146 4 44.9309 1.76601 33.2059 -22.5069 -20.3291 -10.4095 -147 1 41.5145 5.2236 34.9901 10.2672 4.08625 -51.0356 -148 2 40.6676 6.35891 35.268 -24.1778 -10.7223 -7.79527 -149 2 41.3691 7.72376 35.0974 2.95483 13.7574 -3.11119 -150 3 40.6975 8.75349 34.8431 -2.15612 -12.5202 3.44484 -151 4 41.8176 4.64617 35.7553 2.04542 -7.36824 24.1106 -152 4 39.8621 6.3427 34.4551 10.5786 9.41727 7.44594 -153 2 39.8405 6.1283 36.5756 19.8539 -2.67173 26.8296 -154 3 40.7601 5.89106 37.6735 -0.128972 20.3018 -14.678 -155 2 38.9248 4.89402 36.5497 -24.3083 -6.19306 -11.8519 -156 4 39.228 7.01129 36.8511 -0.372961 8.24506 -6.20484 -157 4 41.1549 6.75425 37.8536 -4.13097 -9.7211 -3.01543 -158 4 38.1722 4.94482 35.71 1.05658 9.14576 13.4136 -159 4 38.3953 4.71355 37.5213 -1.28546 9.2328 -6.30902 -160 4 39.3771 3.92967 36.3433 23.1336 -11.0543 -1.24287 -161 1 42.7302 7.8059 35.1562 3.49276 1.34371 4.78693 -162 2 43.5269 8.99303 34.9539 -8.19772 -21.7996 13.9087 -163 2 44.4646 9.39471 36.0778 41.0762 49.5413 -62.5687 -164 3 45.3993 10.2183 35.7654 -29.643 -36.0587 21.7786 -165 4 43.357 7.05719 35.4614 -7.13629 -15.5308 5.06399 -166 4 44.0803 8.92821 34.0189 14.2015 -9.60403 -10.8131 -167 4 42.9032 9.83742 34.7399 -16.6431 23.0824 1.78637 -168 1 44.28 8.95267 37.3076 -5.41717 -6.01048 56.4016 -169 2 45.1954 9.30059 38.3934 14.0544 9.09198 9.45122 -170 2 46.5736 8.71838 38.034 -4.40481 25.0392 4.24124 -171 3 46.7239 7.52665 37.7592 -2.06685 -10.8071 -7.31186 -172 4 43.4369 8.46722 37.66 -0.808029 1.80219 -13.797 -173 4 45.2932 10.4319 38.4595 -5.35026 -12.3633 -15.6489 -174 2 44.7775 8.83735 39.8303 19.1756 -23.9015 -7.23155 -175 2 45.4882 9.63492 40.9425 5.24315 -15.5914 27.8506 -176 2 45.0424 11.1143 41.0465 6.36216 -11.291 -10.339 -177 2 45.9827 11.9035 0.041605 38.3537 -2.96327 34.4916 -178 1 45.5586 13.2421 0.396463 -0.785075 15.3756 28.9492 -179 4 44.9912 7.72238 39.9953 -4.79728 17.8629 -7.78445 -180 4 43.7049 8.96345 39.9422 -22.2512 0.44531 4.07292 -181 4 46.5908 9.56019 40.8161 0.364544 3.82252 -6.52459 -182 4 45.3434 9.10335 0.0599805 -5.24686 13.9981 -23.7842 -183 4 44.0132 11.1324 41.4274 -10.2695 3.39123 6.70816 -184 4 44.9981 11.6023 40.04 1.8072 0.416607 6.15726 -185 4 47.0442 11.9436 41.5493 -17.6115 6.73335 -5.13538 -186 4 46.1824 11.4052 1.05233 -16.0491 -0.928483 -18.7699 -187 4 45.666 13.9003 41.5429 -6.15709 2.25656 -0.794581 -188 4 46.187 13.6261 1.17403 -31.6799 -14.737 -27.4943 -189 4 44.5482 13.2658 0.707841 33.0262 6.71149 -7.77427 -190 1 47.5786 9.61919 37.9975 -0.262725 18.6124 2.96873 -191 2 48.9681 9.33197 37.6414 -20.2336 1.72319 -17.1083 -192 2 49.7588 9.70622 38.88 39.5209 -76.7499 14.8721 -193 3 49.6145 10.763 39.4317 -9.44289 38.5374 13.5639 -194 4 47.4009 10.6083 38.3248 7.77058 -18.5649 -8.96176 -195 4 49.0172 8.23798 37.4216 9.46753 0.884559 0.506936 -196 2 49.3323 10.1282 36.3163 3.6714 0.82331 31.2642 -197 3 48.3563 9.85046 35.3281 -8.1318 -4.77519 -4.71381 -198 2 50.6865 9.72677 35.695 -19.0046 0.743943 -11.7808 -199 4 49.2557 11.2077 36.6021 8.67648 2.0602 -8.11811 -200 4 47.5419 10.2678 35.5977 -2.15846 0.170791 -0.678761 -201 4 50.8563 10.2671 34.7416 2.67544 8.24981 1.47477 -202 4 50.7066 8.66813 35.3754 2.1247 -7.47433 7.78713 -203 4 51.5309 9.954 36.3541 9.43429 -0.352141 7.40173 -204 1 50.5004 8.65755 39.48 -48.513 49.986 -45.0014 -205 2 51.0618 8.74392 40.7907 20.8089 -26.4742 28.5407 -206 2 52.5708 8.35776 40.7906 -32.7343 -31.0986 -30.3541 -207 3 52.9098 7.36002 40.1044 19.6712 31.5314 12.7437 -208 4 50.5882 7.8265 38.898 12.8881 -18.9119 10.2231 -209 4 50.9863 9.78895 41.141 -1.46865 8.60563 4.12328 -210 2 50.3037 7.79505 41.8358 -16.725 28.936 13.8764 -211 2 50.252 6.27959 41.4904 27.2589 15.6434 -4.64867 -212 2 48.8609 8.35011 0.225019 8.85004 14.588 -17.6069 -213 2 49.3953 5.42325 0.497373 -18.8945 7.05888 30.2377 -214 4 50.814 7.95159 0.918621 8.35305 -8.94958 -7.30269 -215 4 51.3186 5.93048 41.4774 -6.84536 -5.23847 5.64953 -216 4 49.9408 6.1608 40.4387 -8.33431 -3.05112 -5.55566 -217 4 48.166 7.96072 41.344 -1.46 7.63128 5.53427 -218 4 48.8165 9.51657 0.246026 0.467008 -30.2893 -0.065267 -219 4 48.5175 7.97406 1.21641 -4.07563 3.27994 -1.48455 -220 4 48.2983 5.58085 0.347667 5.50609 -0.627552 -5.84055 -221 4 49.5344 5.58322 1.60624 7.63779 5.91871 -13.4594 -222 4 49.5909 4.36583 0.361303 3.03099 -20.7712 -9.01704 -223 1 53.3669 9.15083 41.5136 39.5682 14.7354 5.79836 -224 2 54.8443 9.26777 41.6313 -32.7918 27.0996 3.53674 -225 2 0.372396 8.2907 0.722751 15.0567 -33.4937 20.6099 -226 3 54.8856 8.2259 1.87915 11.4238 -3.26125 -20.3466 -227 4 52.9167 9.73978 0.288924 -10.841 14.2188 11.5997 -228 4 0.25416 9.07559 40.636 9.98484 -5.7038 -17.1316 -229 2 0.351513 10.7152 0.19938 0.985642 14.1538 -10.6635 -230 3 54.4575 11.7797 41.7528 -11.3464 -18.6066 -9.73211 -231 2 1.66903 11.1049 41.4122 7.34382 -22.4378 -10.8926 -232 4 0.4803 10.8256 1.29559 2.15483 -15.9854 6.57991 -233 4 54.1789 12.1729 0.660397 -4.76608 7.18995 2.46446 -234 4 2.02372 12.0909 41.706 2.9877 17.6459 6.95349 -235 4 1.57896 11.139 40.2943 0.339955 -2.68366 6.65003 -236 4 2.50746 10.4017 41.6821 -7.50419 3.69742 -2.77337 -237 1 1.45709 7.55056 0.343709 0.783377 10.0466 -6.42735 -238 2 2.26763 6.65075 1.15078 -32.6055 -6.94536 -7.22798 -239 2 3.71498 6.9634 0.985171 49.9575 39.4499 -62.468 -240 3 4.16139 7.41516 41.7733 -24.7374 -20.1855 46.264 -241 4 1.86812 7.64334 41.3079 -3.10568 2.79536 2.39364 -242 4 2.02547 6.77359 2.21072 -7.15361 5.99983 10.1715 -243 2 1.97017 5.19949 0.677115 9.24237 23.8034 -8.70369 -244 2 0.525 4.76245 0.942436 -1.25511 -23.3688 27.6866 -245 2 0.292475 3.39123 0.300736 12.896 -21.1671 11.4366 -246 2 0.300138 4.59931 2.47443 -32.0383 1.7301 9.08136 -247 4 2.70003 4.54767 1.15632 6.2908 -16.3803 10.1517 -248 4 2.22696 5.13751 41.5068 -3.29253 -1.30987 -4.15087 -249 4 54.7656 5.47042 0.590489 -8.39992 14.3218 -15.0438 -250 4 54.2418 3.05018 0.328915 -13.2626 1.11831 3.00682 -251 4 0.884488 2.58096 0.823664 -4.50955 14.351 -5.98985 -252 4 0.593908 3.34298 41.1636 3.48003 3.40906 -16.1017 -253 4 0.952355 3.83641 2.92287 8.67303 -5.41594 2.10418 -254 4 54.195 4.2418 2.71744 29.7111 15.4634 -7.25797 -255 4 0.523461 5.5584 3.03176 -8.55492 -11.4476 -4.98522 -256 1 4.54724 6.69628 2.0028 -11.6083 -5.66543 -5.23244 -257 2 5.9708 6.78048 2.07185 29.6953 24.7002 11.5216 -258 2 6.62679 5.47067 2.57826 -56.9161 -25.5018 -48.7527 -259 3 7.55514 5.44421 3.3345 43.3901 -4.04961 27.9945 -260 4 4.11753 6.29088 2.82459 -1.31884 -6.15538 19.0144 -261 4 6.38329 6.99012 1.0501 -1.44469 -12.2628 1.79191 -262 2 6.4556 7.99651 2.97484 -29.1307 10.2847 -18.0571 -263 2 6.5028 9.34873 2.22705 -18.2939 24.7932 5.04877 -264 2 6.67525 10.5485 3.20576 -19.6949 -28.8822 -17.9407 -265 3 7.83409 10.9407 3.49149 14.4815 4.00472 5.8048 -266 3 5.6204 11.0576 3.67938 3.00737 1.04452 3.25275 -267 4 7.46376 7.72864 3.29072 15.5933 3.84479 14.8832 -268 4 5.82416 8.22265 3.87848 3.62309 -20.6245 -0.107855 -269 4 5.50278 9.55154 1.65377 27.7023 -9.35583 7.15892 -270 4 7.36204 9.37759 1.52673 -1.86837 -2.39822 -10.1271 -271 1 6.01547 4.32119 2.13096 24.825 18.8056 21.8908 -272 2 6.40109 2.94617 2.38906 -11.7575 -20.1643 -12.9237 -273 2 7.81521 2.61654 1.77783 -56.2322 2.45294 33.4207 -274 3 8.31478 3.35811 0.966233 17.239 19.087 -22.9985 -275 4 5.23593 4.40493 1.50032 -13.4301 6.78787 -12.4159 -276 4 6.42741 2.74871 3.48587 6.57798 6.02642 3.28221 -277 2 5.2086 2.00284 1.82478 32.9723 -19.5112 -16.552 -278 2 3.90497 2.10853 2.63909 4.11684 35.775 58.6384 -279 2 4.90372 2.28313 0.318971 -25.0993 -16.9694 6.10511 -280 4 5.56913 0.900136 1.85726 -4.66192 22.2662 6.6067 -281 4 4.03562 1.77943 3.74204 2.08752 -4.13501 -29.3045 -282 4 3.08076 1.58512 2.20328 -21.6762 -25.4002 -11.7361 -283 4 3.47043 3.14079 2.79739 15.5883 -5.24062 -11.8252 -284 4 4.40039 3.24668 0.146776 -5.79992 5.24774 -1.28692 -285 4 4.20501 1.47402 41.8336 8.41255 14.6516 3.66501 -286 4 5.77159 2.28177 41.569 16.6343 -1.64949 -4.80555 -287 1 8.4358 1.54559 2.27475 36.6082 -11.5601 -11.8896 -288 2 9.77403 1.09441 1.8307 -27.8835 12.6882 -14.7267 -289 2 9.60932 41.7912 0.904414 -8.95822 -4.80133 -2.77359 -290 3 8.60977 41.0717 1.04857 16.9017 -0.350054 -8.54673 -291 4 7.96937 0.851078 2.83344 -16.1443 -13.3321 15.6909 -292 4 10.1447 1.96102 1.23179 21.7718 -7.90657 2.9301 -293 2 10.6071 0.627222 3.03652 -0.441548 -3.06629 28.3632 -294 2 11.1182 1.69736 4.03374 -39.6019 -9.33118 23.345 -295 2 12.4276 2.26482 3.60541 40.3504 -3.80329 2.03759 -296 3 13.4833 1.65854 4.00477 -10.9735 16.3163 -6.96273 -297 3 12.4619 3.21875 2.76405 -4.75337 -1.04793 7.93588 -298 4 11.5429 0.117807 2.72279 -4.90068 -9.43781 -6.0473 -299 4 9.98495 41.7532 3.61242 16.0495 13.2539 -10.4034 -300 4 11.2741 1.17979 5.05068 -3.18835 9.28581 -16.8758 -301 4 10.3234 2.48031 4.23808 10.2695 -6.11036 -3.24845 -302 1 10.6563 41.4604 0.0588169 -6.20046 -15.666 -8.24155 -303 2 10.7096 40.1842 41.1911 4.64874 21.5238 9.65168 -304 2 10.6577 38.9638 0.161439 -6.67174 -46.3648 23.9629 -305 3 10.1435 37.8848 41.6696 11.1653 29.5239 15.2576 -306 4 9.85832 40.1011 40.5066 -14.3391 4.69386 -5.52668 -307 2 12.0141 40.2124 40.3653 4.26726 1.71904 -5.44169 -308 2 12.4668 41.6661 40.4777 -1.00635 15.6111 -33.0282 -309 2 11.8673 0.323303 41.767 -12.6506 -21.5702 -15.1443 -310 4 11.8545 39.873 39.2959 0.539662 6.91875 10.5587 -311 4 12.8304 39.5641 40.7546 -3.32338 -3.68521 7.20301 -312 4 12.0951 0.327352 39.5607 -0.26902 -6.73625 15.8499 -313 4 13.5766 41.7696 40.398 -3.05617 -0.547794 6.53436 -314 4 11.6542 1.3898 41.6565 2.06281 16.0871 1.21765 -315 4 12.5433 0.162045 0.691867 15.5992 2.8717 16.0141 -316 1 11.2193 39.0766 1.4086 -4.36655 24.7542 -22.059 -317 2 11.4309 38.0888 2.42328 2.01986 -2.25877 10.0578 -318 2 10.2357 37.7662 3.3374 -3.13249 5.62439 -12.9442 -319 3 10.4243 36.9709 4.25096 -6.41092 -9.96708 1.94465 -320 4 11.5904 40.0068 1.66465 -1.36758 -8.10945 4.45955 -321 4 11.6246 37.1209 1.91909 1.66244 -5.96089 -4.69733 -322 2 12.7089 38.4628 3.26447 -19.7243 1.96837 18.865 -323 3 12.593 39.7548 3.85012 -16.3579 -13.4437 -0.292868 -324 4 13.6002 38.4999 2.63657 13.9756 -7.10852 -11.694 -325 4 12.8962 37.7302 4.10036 -1.36843 4.44789 -10.4248 -326 4 11.9859 39.6657 4.60642 10.4094 13.6351 -5.41979 -327 1 9.02275 38.3618 3.12708 -24.8633 34.0603 -47.8229 -328 2 7.7797 38.1104 3.9237 -5.5143 -4.40103 -12.4219 -329 2 6.80948 37.1627 3.16843 27.134 16.5749 8.61656 -330 3 6.86683 37.0056 1.95165 6.52379 13.0808 -10.3152 -331 4 8.81363 38.9852 2.21874 13.7891 -35.0234 50.9651 -332 4 8.06628 37.5753 4.84119 7.22917 -10.5654 7.4735 -333 2 7.01568 39.4093 4.3407 2.69101 -11.9593 -14.7657 -334 2 7.81876 40.1019 5.42325 -6.79454 3.60365 -28.1432 -335 3 8.28496 41.241 5.20721 -2.75331 10.4655 -0.123769 -336 3 8.08719 39.4782 6.47272 0.652509 -5.2024 22.4807 -337 4 5.97814 39.1687 4.67547 5.82193 1.31451 7.85599 -338 4 6.83632 40.0167 3.42407 6.48365 7.00102 3.75656 -339 1 5.92582 36.4787 3.90047 -14.2639 -13.8348 21.4567 -340 2 4.95916 35.6178 3.24268 -4.4575 6.83929 8.3992 -341 2 3.83929 36.4769 2.71202 -44.4588 -49.3176 -48.5312 -342 3 3.60925 37.6169 3.05258 2.07424 26.7384 14.4764 -343 4 5.8145 36.534 4.942 7.63157 5.21975 -16.3776 -344 4 5.40617 35.1414 2.34351 4.65472 -4.22423 0.555341 -345 2 4.39718 34.509 4.16235 13.2774 -34.7614 9.16528 -346 3 3.98438 35.0519 5.39575 -10.4467 6.31908 32.28 -347 2 5.50619 33.4543 4.48033 -18.4692 -3.54598 29.0115 -348 4 3.53919 33.9402 3.74776 -4.47694 5.79242 -10.2957 -349 4 3.62452 34.3759 6.00064 11.5458 5.5573 -22.0279 -350 4 5.86065 32.9579 3.58801 8.19644 -6.15464 -22.9143 -351 4 5.08151 32.5761 5.12909 16.3877 29.7333 -11.6263 -352 4 6.39565 33.9521 4.95041 -3.85278 -8.84208 3.35803 -353 1 2.97294 35.7888 1.83357 24.6732 25.9217 25.2152 -354 2 1.71267 36.3687 1.37347 -5.03432 -5.896 10.5631 -355 2 0.744229 36.5497 2.58991 -5.24139 24.3125 -23.8477 -356 3 54.9871 37.5497 2.63122 18.6385 -17.0409 3.73872 -357 4 3.28773 34.8825 1.44268 -6.98273 2.93822 -0.272558 -358 4 1.87243 37.434 1.07109 4.86902 -3.5162 -5.74397 -359 2 1.111 35.5523 0.154125 -16.9781 -2.34719 28.1775 -360 2 1.71191 35.9998 40.7076 5.75717 0.931703 -28.4951 -361 2 54.5365 35.7134 0.116808 -8.16561 0.919103 1.38616 -362 2 3.27145 35.9095 40.6267 -43.0781 7.09941 -3.6072 -363 4 1.31237 34.4411 0.36052 2.96229 18.9121 -10.1464 -364 4 1.38444 37.0145 40.3207 4.07875 -5.77915 19.4423 -365 4 1.27316 35.3433 39.9124 8.37762 -5.40948 6.65521 -366 4 54.0772 35.0942 41.2103 3.74338 3.48587 4.89864 -367 4 54.2123 36.7722 41.8688 5.5832 -2.69651 -3.34762 -368 4 54.0157 35.4055 1.08169 10.5414 -0.491815 -14.4897 -369 4 3.61367 34.902 40.8802 7.83264 -12.2373 1.45006 -370 4 3.69229 36.6315 41.3343 12.2091 5.94613 6.19684 -371 4 3.59275 36.1798 39.604 6.95495 -3.49191 -4.00644 -372 1 0.74604 35.6172 3.54454 -3.3388 -35.9018 49.598 -373 2 0.0112331 35.6552 4.85892 21.257 7.22823 -39.6883 -374 2 0.198256 37.0471 5.48367 -2.86302 -31.8341 -17.2866 -375 3 54.1912 37.6952 5.75353 -1.48181 26.0574 3.92406 -376 4 1.16676 34.6739 3.4098 -0.571923 12.3969 -9.16993 -377 4 53.9399 35.5324 4.59955 -13.6683 1.62606 4.36563 -378 2 0.479844 34.4894 5.77304 -8.63544 -0.437888 22.4632 -379 2 54.7769 34.3327 7.14546 -8.87326 -9.27459 2.92058 -380 2 0.0146857 35.4787 8.12524 6.60033 -5.57439 2.5368 -381 3 54.0952 36.3427 8.3329 8.35004 -1.43527 5.86114 -382 3 1.11008 35.478 8.75909 4.47833 6.11486 1.03148 -383 4 1.57132 34.5563 5.98457 -0.698959 1.91632 -4.64924 -384 4 0.309529 33.5134 5.28188 2.4365 -3.54209 -11.468 -385 4 0.179249 33.4003 7.64738 0.479338 5.67065 -5.66203 -386 4 53.6776 34.105 7.04833 9.83525 6.91672 -4.06122 -387 1 1.48459 37.3964 5.63734 26.9411 18.0032 -4.38534 -388 2 2.00708 38.6625 6.18614 -17.3218 -26.0277 -29.9987 -389 2 1.56827 39.8885 5.33406 1.07082 -15.6319 68.2882 -390 3 1.08143 40.8395 5.94485 1.04665 3.34176 -10.6171 -391 4 2.21263 36.6994 5.39095 -3.57075 5.04293 0.958686 -392 4 1.48422 38.7142 7.17744 15.2971 12.5748 0.959573 -393 2 3.55969 38.5843 6.25222 7.32448 -15.8569 15.0135 -394 2 4.09689 39.7132 7.09894 -5.63198 1.92213 9.01267 -395 3 4.56636 40.7179 6.56654 0.030916 3.04529 -1.1693 -396 1 3.96361 39.556 8.43894 1.042 12.9555 16.4237 -397 4 4.05831 38.7157 5.24953 -10.2579 -5.90723 4.64011 -398 4 3.91694 37.5778 6.70114 -5.07122 23.1073 -10.2752 -399 4 3.40266 38.7698 8.86734 10.6722 14.2638 -7.23316 -400 4 4.31989 40.3411 9.06061 -10.7144 -22.9188 -14.0526 -401 1 1.60475 39.819 4.02334 -43.55 39.5967 -43.6917 -402 2 0.959151 40.8062 3.12947 9.93922 10.0651 20.657 -403 2 54.4776 41.0208 3.48285 -52.4492 -13.4217 15.5726 -404 3 53.9715 0.237442 3.65017 19.1527 -10.2385 2.60078 -405 4 2.04263 39.1125 3.49268 25.4866 -43.7222 -11.6271 -406 4 1.43469 41.7946 3.36052 -1.16639 -0.650149 -3.04645 -407 2 1.13376 40.5205 1.61049 -4.45578 -2.70165 -27.9407 -408 2 0.490261 41.6149 0.695896 4.53105 0.20202 29.6943 -409 2 2.64975 40.4484 1.23692 -3.92583 -1.39436 -18.6979 -410 4 0.60342 39.5705 1.32385 8.41785 -1.89228 7.96418 -411 4 54.3692 41.6195 0.82936 4.25856 9.6792 3.81375 -412 4 0.622371 41.4492 41.5424 7.52435 -6.48816 -19.7965 -413 4 0.973053 0.688907 0.936332 -12.1275 -4.49455 -2.44597 -414 4 2.86969 40.4983 0.122209 -12.9804 -12.5133 18.6513 -415 4 3.14027 39.5547 1.69882 2.20392 3.04031 -6.93039 -416 4 3.17994 41.3387 1.56797 8.55742 10.8937 16.8775 -417 1 53.6665 39.902 3.64569 3.02926 35.878 11.6697 -418 2 52.2466 39.9148 4.06102 19.2385 27.0707 -26.8098 -419 2 52.053 40.5369 5.44904 5.36155 -11.3244 -6.70427 -420 3 51.0493 41.2119 5.6977 3.00195 1.8183 -1.23959 -421 4 54.0359 38.9941 3.4462 12.1828 -26.316 -3.91411 -422 4 51.7731 40.6655 3.34079 -4.82064 -14.7659 11.8755 -423 2 51.582 38.5149 3.95778 -5.61462 -20.1546 -9.91009 -424 2 51.4355 37.9559 2.49174 21.0062 -12.2216 22.8132 -425 2 51.0144 36.4629 2.37849 -12.7289 -13.0945 -11.3158 -426 2 50.8009 35.9817 0.883468 22.3055 45.8074 13.5352 -427 1 50.1864 34.6873 0.684667 2.36531 28.1154 -10.556 -428 4 50.5344 38.5648 4.38466 13.3699 -2.49694 2.21203 -429 4 52.2198 37.7725 4.53757 -13.8611 9.51826 -2.20414 -430 4 52.4594 37.9738 2.01537 -10.7122 14.3169 -4.94324 -431 4 50.6781 38.6054 2.01085 7.27079 0.282464 -15.5314 -432 4 50.0599 36.3043 2.92579 -2.19776 -0.350037 2.41174 -433 4 51.7586 35.7685 2.83822 0.223715 4.6579 4.31096 -434 4 51.8274 35.9658 0.402852 -15.0801 -2.53131 0.358002 -435 4 50.2142 36.8299 0.38331 4.02889 -26.7998 -2.47013 -436 4 50.6312 33.9821 1.2741 -7.74727 -6.99272 -14.4028 -437 4 50.1255 34.5169 41.5875 17.6482 -15.4813 7.31014 -438 4 49.2229 34.7469 0.909632 -22.6621 -5.40937 19.0501 -439 1 53.014 40.2496 6.3528 -7.33511 22.7823 24.6419 -440 2 53.0995 40.7279 7.73814 -49.8191 -29.044 -3.24915 -441 2 53.1557 0.329785 7.7965 36.8238 12.814 -39.8954 -442 3 52.5287 0.997511 8.60414 -15.9304 4.02299 13.5617 -443 4 53.7341 39.5741 6.15629 12.7417 -17.108 -13.0125 -444 4 52.0658 40.401 8.2322 35.0205 13.5384 -7.46142 -445 2 54.2887 40.0362 8.44194 -31.1952 -6.28028 37.9979 -446 4 54.3393 40.3597 9.51814 11.9598 15.0179 -15.3163 -447 4 0.207826 40.1934 7.85611 17.4499 5.7482 6.56468 -448 4 54.1321 38.9464 8.61757 0.233079 -2.0185 -17.8759 -449 1 53.9798 0.938968 6.8679 -0.195991 -19.5991 -5.8991 -450 2 54.0539 2.3703 6.69095 -13.0728 33.3033 12.6105 -451 2 52.7411 3.03405 6.19669 -13.7918 -57.342 -43.9621 -452 3 52.3429 4.1409 6.51048 0.805927 21.8583 24.6591 -453 4 54.6966 0.402301 6.30051 -22.9471 7.504 14.9388 -454 4 54.1387 2.85352 7.70963 6.90446 -7.48262 -5.16091 -455 2 0.230181 2.82991 5.77971 -8.39605 37.5401 -18.7849 -456 2 1.62806 2.36187 6.13631 43.8101 -17.859 13.5365 -457 2 2.01439 2.63812 7.6434 4.44409 -15.8917 -34.667 -458 2 3.251 1.82053 8.03886 10.3698 -25.435 21.3536 -459 1 3.78609 2.13458 9.37971 -1.03569 -21.7613 -70.4054 -460 4 0.236987 4.00662 5.72725 -0.841737 -32.3075 1.88093 -461 4 55.0233 2.47547 4.72977 -1.92078 4.0191 4.58104 -462 4 2.43886 2.84427 5.52141 -13.7997 6.98566 -1.14785 -463 4 1.8001 1.26942 5.8525 -13.1218 12.7308 11.199 -464 4 1.17734 2.2629 8.25415 -4.76662 9.03037 15.6753 -465 4 2.26439 3.72233 7.77766 -11.2971 -1.006 3.39024 -466 4 4.0605 1.91272 7.29579 6.96563 5.43042 -1.59904 -467 4 3.03028 0.709673 8.06144 -4.99399 12.6268 -3.20223 -468 4 3.89697 1.2978 9.90866 2.2165 -13.9672 17.3419 -469 4 3.11983 2.70535 9.83652 -2.18207 25.7622 26.4666 -470 4 4.71792 2.51816 9.23842 -3.78155 13.4581 18.6473 -471 1 52.0021 2.30339 5.27929 12.8772 20.7449 44.6796 -472 2 50.6928 2.72834 4.84618 -13.8318 -0.832969 -24.58 -473 2 49.579 2.58092 5.91693 0.565718 25.7533 -2.22664 -474 3 48.7752 3.51298 6.10069 9.60089 -13.9081 0.0850852 -475 4 52.4111 1.47967 4.84803 3.54375 -13.752 -6.04623 -476 4 50.7183 3.81521 4.5849 2.62435 0.742467 8.46338 -477 2 50.3339 2.0499 3.47904 12.4361 -26.7668 8.24264 -478 2 51.3981 2.34325 2.36407 -25.9391 22.844 -14.5031 -479 2 48.9153 2.37958 2.98651 -2.89914 40.9383 9.35249 -480 2 51.1891 1.41918 1.15407 38.5806 -15.4927 -30.3188 -481 4 50.4158 0.92469 3.65006 -8.90797 13.02 4.48026 -482 4 52.4055 2.20648 2.74929 18.7984 -5.45377 5.09466 -483 4 51.3666 3.42411 2.00589 -1.76359 -13.5005 7.53435 -484 4 48.1353 2.36077 3.79579 2.75746 -16.6411 -10.078 -485 4 48.6799 1.76326 2.11438 -14.9792 -11.0957 -5.84075 -486 4 48.8325 3.45193 2.63807 7.50371 -11.7896 -0.401559 -487 4 52.1004 1.43799 0.414216 -21.3416 1.39174 26.2203 -488 4 50.3409 1.68288 0.503068 -10.2032 3.93981 2.99084 -489 4 51.0565 0.33979 1.46483 1.72575 11.8892 -3.22767 -490 1 49.5807 1.53255 6.75244 19.5889 -24.3514 7.76629 -491 2 48.7262 1.39688 7.92951 3.12598 20.2674 -1.73108 -492 2 48.8873 2.63773 8.86406 -22.8968 -16.6402 -5.42224 -493 3 47.8891 3.05472 9.45614 -0.472007 6.27789 -5.95623 -494 4 50.2352 0.731103 6.58688 -10.8709 15.7502 1.66713 -495 4 47.6402 1.39986 7.60999 11.2933 -0.131061 -1.07735 -496 2 49.0614 0.0990051 8.70607 -29.9824 -25.1823 -11.7347 -497 2 48.2869 41.7602 10.01 13.4599 -0.122667 29.7563 -498 2 46.7828 0.0292377 10.0132 -0.929007 -24.4408 -23.1824 -499 3 46.2118 0.52149 10.9702 -12.9016 15.2185 13.9881 -500 1 46.1401 41.3429 8.96595 27.5879 22.2376 34.4467 -501 4 50.107 0.108866 8.97457 27.7162 -1.73681 3.74735 -502 4 48.8999 41.0818 8.03917 5.36927 20.2302 10.0129 -503 4 48.7183 0.460982 10.852 -8.35522 8.57003 -12.646 -504 4 48.4869 40.755 10.454 -1.65554 -4.90235 -14.5783 -505 4 46.6392 40.8985 8.22302 16.4703 -11.2583 -22.7525 -506 4 45.1487 41.2958 8.97726 -40.9601 -1.33251 0.190018 -507 1 50.0995 3.17318 9.05078 3.95851 -0.0485648 -3.79593 -508 2 50.3325 4.25644 9.97415 17.5873 21.0859 -2.62556 -509 2 49.9752 5.63804 9.37548 -18.0954 -29.5198 29.938 -510 3 49.379 6.45094 10.0988 9.73071 -4.74536 -2.58342 -511 4 50.9107 2.76055 8.59957 11.9693 -5.38147 -4.75744 -512 4 49.6509 4.09994 10.8399 -6.9467 2.38538 1.23714 -513 2 51.7744 4.26209 10.561 -12.6039 -21.2869 -0.279481 -514 2 51.8614 5.17465 11.7883 77.4573 -1.34868 -55.222 -515 3 50.9415 5.19238 12.5756 -62.6641 4.37367 45.7089 -516 3 52.9385 5.83334 11.9521 -15.5069 -3.45829 -0.856418 -517 4 52.5513 4.49045 9.80335 -1.41111 7.91559 -3.33271 -518 4 51.9847 3.17606 10.8252 3.56611 15.7947 8.37571 -519 1 50.1134 5.83384 8.05697 5.03044 -3.38183 -24.9476 -520 2 49.6949 7.07302 7.45907 -6.39224 21.6045 -14.6025 -521 2 48.2404 7.19765 6.96855 9.41443 -40.5535 -11.5325 -522 3 47.5994 8.23003 7.09737 -2.60339 17.4007 5.13595 -523 4 50.5903 5.18529 7.39903 -4.72806 0.48988 13.3104 -524 4 49.6568 7.79446 8.28532 6.84483 14.8177 6.93296 -525 2 50.7045 7.63108 6.39006 -19.8247 -9.47824 8.02755 -526 2 50.6996 6.84785 5.08902 -10.629 2.31661 -15.1243 -527 2 51.6586 7.26626 3.9659 -11.3496 43.5825 3.95364 -528 2 53.1317 7.00105 4.2557 32.8208 18.7244 -18.8206 -529 1 53.7683 7.95578 5.14747 -10.6729 7.59108 -11.9454 -530 4 51.7028 7.64661 6.81348 16.7201 -1.45014 11.0251 -531 4 50.4708 8.68128 6.19684 -5.34256 14.1207 -5.41714 -532 4 49.6713 6.8702 4.6668 -0.861277 1.74329 -1.61352 -533 4 50.8688 5.79892 5.31654 5.28855 -19.0543 2.54637 -534 4 51.4741 8.35024 3.65396 8.42695 -12.5098 16.2485 -535 4 51.3565 6.79125 3.04708 -1.5826 -26.0582 -19.3792 -536 4 53.7673 7.0998 3.31183 -20.6632 -9.77681 9.39502 -537 4 53.2972 5.98514 4.64126 3.7215 -8.75629 2.11801 -538 4 53.3251 8.87081 5.17658 4.71004 0.103302 -2.74719 -539 4 54.7439 8.12131 4.95956 10.0262 2.1061 -7.58392 -540 4 53.7752 7.60869 6.06781 -3.05466 -8.65204 35.212 -541 1 47.7159 6.1092 6.3306 31.3529 14.3598 14.0351 -542 2 46.4076 6.11425 5.7591 -25.7668 -19.0326 -13.8071 -543 2 45.4013 5.23171 6.47844 56.1675 -11.9112 16.6864 -544 3 44.23 5.34684 6.24133 -49.2229 2.39302 -4.99484 -545 4 48.3398 5.28969 6.15889 -17.2258 10.451 -1.21207 -546 4 45.9358 7.11624 5.83656 4.3919 7.44058 4.79016 -547 2 46.401 5.6982 4.25555 12.45 -16.5042 -24.1702 -548 2 46.8608 6.82251 3.28226 -4.83626 -15.1342 -13.4955 -549 2 46.0803 8.13881 3.30599 -14.5444 -4.79224 -13.1752 -550 3 44.9716 8.27119 2.67975 10.7775 -8.64163 7.28309 -551 3 46.5691 9.08454 3.95876 4.86602 16.815 8.62941 -552 4 45.3845 5.39013 3.90204 -1.72737 6.76951 8.44594 -553 4 47.0179 4.72632 4.06618 -9.2699 26.8442 8.77601 -554 4 46.8747 6.40942 2.20799 2.04532 8.89503 18.2744 -555 4 47.9008 7.08537 3.56457 7.18737 -1.18981 -5.53646 -556 1 45.8799 4.29222 7.33829 -37.7514 2.20406 -4.61566 -557 2 44.9987 3.41141 8.06424 -3.99299 1.7641 -5.76947 -558 2 44.3276 2.33248 7.21969 -45.1266 -42.7281 27.6017 -559 3 43.411 1.613 7.73718 25.6836 24.6852 -13.962 -560 4 46.8488 4.10168 7.49502 31.0353 -1.43619 1.82022 -561 4 45.5349 2.87862 8.87403 3.80662 2.65181 2.49747 -562 4 44.2009 4.01738 8.56522 2.51171 -3.43938 -1.53795 -563 1 44.7359 2.05713 5.97006 1.92732 3.23614 21.462 -564 2 44.1948 0.978467 5.13766 -26.7101 17.135 -13.9432 -565 2 44.8486 41.5478 5.5025 3.41127 -20.6454 16.5554 -566 3 46.0871 41.4431 5.57675 -14.0525 11.0231 2.35631 -567 4 45.5581 2.59183 5.73006 15.6975 -3.64086 -27.3416 -568 4 43.0338 0.980574 5.28193 28.569 -9.56263 1.83686 -569 2 44.4255 1.37435 3.62453 6.02041 -5.1027 -4.41971 -570 2 43.5303 2.62118 3.29791 4.64703 16.7196 -23.7169 -571 2 44.2051 0.148173 2.67978 -29.1583 2.83252 11.5038 -572 2 43.5747 3.10962 1.83395 1.21002 2.08355 -6.515 -573 4 45.4937 1.66977 3.44724 -0.165314 0.952935 9.41179 -574 4 43.8006 3.52551 3.92139 -2.56937 -12.5949 1.07415 -575 4 42.4611 2.43664 3.46298 -10.2855 -9.14552 12.9963 -576 4 44.5119 0.377143 1.64896 8.27723 -0.881131 -7.54742 -577 4 43.1044 41.7625 2.59144 16.8524 3.81389 6.96191 -578 4 44.7846 41.171 3.05101 -3.46686 1.83863 -12.0461 -579 4 44.5392 3.56167 1.57116 9.55733 8.13116 4.62467 -580 4 42.7809 3.86627 1.57982 6.14378 -4.69974 7.81616 -581 4 43.4757 2.31615 1.08375 -8.22918 -11.6964 -1.57482 -582 1 44.0839 40.4233 5.76821 21.932 -1.5334 -8.86254 -583 2 44.7424 39.1674 6.24443 -3.28027 29.5462 -2.23354 -584 2 45.6232 38.4648 5.15467 16.5957 -3.17533 31.1682 -585 3 45.1655 38.1269 4.0769 -9.06079 2.14789 -9.97198 -586 4 45.3594 39.5074 7.13461 -7.15079 -15.4686 -7.49065 -587 2 43.5266 38.3049 6.70081 12.2837 2.36218 -7.01546 -588 2 42.3912 38.8204 5.83129 -5.25874 0.19697 14.2242 -589 2 42.6515 40.3318 5.90174 -25.8883 17.7161 37.6601 -590 4 43.2615 38.5482 7.76954 6.63706 -13.879 -3.94164 -591 4 43.7406 37.2122 6.50504 -6.24398 7.50926 12.4246 -592 4 41.3856 38.4747 6.1895 5.24712 7.09666 -1.13826 -593 4 42.5101 38.4102 4.83081 -0.0162975 -1.57753 -20.806 -594 4 42.2783 40.7857 6.94925 18.7272 -16.9878 -38.5107 -595 4 42.0764 40.8825 5.13323 2.00122 -0.967094 -8.03005 -596 1 46.8623 38.0021 5.57674 -15.3549 -23.0767 -9.82664 -597 2 47.7161 37.0187 4.84527 -3.88045 42.2808 23.2471 -598 2 47.0384 35.8723 4.15029 10.1677 -9.37304 -39.3599 -599 3 47.4551 35.4743 3.0324 -9.4669 19.846 29.5852 -600 4 48.2252 37.6386 4.0698 7.54977 -11.2433 -2.33648 -601 2 48.6452 36.5035 5.99482 -10.0312 13.1223 -5.95218 -602 2 48.8959 37.7819 6.80046 -4.41071 -5.72741 24.5975 -603 2 47.4918 38.4151 6.80561 23.284 1.3706 -4.72721 -604 4 49.5844 36.0861 5.59811 5.91725 -9.04521 -0.913385 -605 4 48.1158 35.748 6.64071 6.83063 -0.71303 -5.46675 -606 4 49.6383 38.4449 6.34864 7.02588 7.83512 -10.7506 -607 4 49.3019 37.5753 7.85532 -11.9914 1.76609 -18.7023 -608 4 47.544 39.5162 6.85821 3.72706 6.34433 1.60956 -609 4 46.9486 38.0654 7.68542 -11.5693 -5.06488 12.3189 -610 1 46.0019 35.318 4.78064 -26.4221 -3.88232 27.7903 -611 2 45.3025 34.13 4.26579 26.8092 19.3149 11.5505 -612 2 44.4585 34.46 3.02929 16.6723 1.23881 35.6677 -613 3 44.3932 33.6565 2.12406 -6.96945 -13.3218 -23.6344 -614 4 45.6895 35.6839 5.72645 6.17072 -11.3773 -21.4598 -615 4 46.1371 33.4525 3.9443 -9.57056 -4.48549 -9.01935 -616 2 44.5851 33.4333 5.41517 7.28023 -34.3989 -9.31284 -617 2 43.896 32.1478 4.95943 -2.5072 53.7563 23.2534 -618 3 42.6929 32.0377 5.28407 -11.6877 -17.8688 -5.68187 -619 3 44.6212 31.2997 4.42805 15.8429 -32.9345 -13.4225 -620 4 43.8908 34.1037 5.87793 -28.8167 18.0933 10.1447 -621 4 45.2673 33.1449 6.25678 1.67129 3.14432 -6.05002 -622 1 43.9425 35.6996 2.93756 -0.354949 -32.7532 -51.8723 -623 2 43.3733 36.2033 1.70184 -38.6892 -13.1006 14.7431 -624 2 44.3694 36.8017 0.73913 15.0439 4.82349 -39.1461 -625 3 44.0609 36.9601 41.4463 -0.757384 -5.0254 19.6545 -626 4 44.0082 36.3398 3.67638 4.88567 37.3717 42.7902 -627 4 42.8639 35.3314 1.17484 15.8753 7.76257 0.915116 -628 2 42.1931 37.1947 1.98861 35.687 20.598 -23.7763 -629 2 41.116 36.6037 2.88066 -6.28281 10.7168 27.7809 -630 2 39.8788 37.4748 2.97821 -20.6793 -12.2331 -39.8799 -631 3 39.5744 38.0012 4.02693 -4.5695 14.1805 28.3661 -632 1 39.0796 37.534 1.86047 23.989 -9.69865 9.57867 -633 4 41.7899 37.5369 1.00167 -6.59533 -6.76427 4.06671 -634 4 42.6371 38.1477 2.39011 -7.96796 -7.2267 7.32793 -635 4 41.4745 36.4913 3.95075 -0.75248 -0.913082 -13.6466 -636 4 40.7949 35.61 2.55083 -3.16107 -12.1939 -5.02302 -637 4 39.3636 37.1043 0.951835 -4.89499 3.13933 11.6446 -638 4 38.1602 37.9899 1.92801 1.07188 2.17452 -2.18356 -639 1 45.5977 37.1878 1.1702 -15.0402 3.91697 -26.2999 -640 2 46.6124 37.7593 0.269692 0.961344 -25.1749 -6.20454 -641 2 47.1251 36.6298 41.227 -15.6894 27.1972 18.7996 -642 3 47.6617 35.6605 41.7393 11.2436 -21.3221 -9.23089 -643 4 45.7953 37.0706 2.14421 15.4189 2.49224 25.3654 -644 4 46.1246 38.4981 41.5406 -7.74237 14.7139 -7.84953 -645 2 47.8075 38.4099 1.03092 10.1012 15.6193 -18.1996 -646 2 47.4246 39.6903 1.82563 -12.4684 -22.6418 23.6998 -647 2 48.6005 40.4099 2.51691 -17.3417 -7.9082 6.23218 -648 3 49.6876 40.5582 1.97833 4.99301 -0.872474 -9.60266 -649 1 48.339 40.8761 3.75079 34.2245 13.1834 24.2049 -650 4 48.6123 38.7237 0.293834 -9.9427 -4.45455 6.13719 -651 4 48.2879 37.6501 1.66455 2.7768 -3.8165 9.90104 -652 4 46.6323 39.34 2.60232 21.0344 18.1725 -15.5096 -653 4 46.9544 40.4315 1.1644 -6.65764 6.44375 -5.56957 -654 4 47.4103 40.9551 4.17425 -6.86232 -2.61251 -1.04516 -655 4 49.1568 41.2536 4.3255 -23.3959 -10.5461 -18.532 -656 1 47.0132 36.8194 39.8944 4.79393 -10.5252 -5.84263 -657 2 47.6604 36.043 38.8342 19.1375 -30.0942 8.85154 -658 2 48.4687 37.0132 37.9763 6.82075 18.1877 -22.3602 -659 3 47.9595 37.6039 37.0009 8.77071 -9.81154 18.2462 -660 4 46.405 37.5569 39.5258 -2.34297 5.9549 -2.23138 -661 4 48.4229 35.2731 39.2798 -19.3933 25.0679 -4.92238 -662 2 46.6775 35.1997 37.9517 0.490197 24.678 -10.7229 -663 2 46.0672 34.0096 38.7198 -38.9175 -0.700818 10.3629 -664 2 46.8744 32.685 38.9073 -3.26917 9.79703 -36.9848 -665 1 47.7628 32.6295 40.0786 -15.9706 28.2316 14.6984 -666 2 48.51 31.5331 40.3435 -4.63001 14.745 41.8738 -667 1 48.7312 30.5422 39.5064 -7.34995 -4.23697 -9.55446 -668 1 48.9018 31.3819 41.635 -19.9532 28.2508 -37.0556 -669 4 47.1729 34.8887 37.0027 6.80802 -10.5296 7.48075 -670 4 45.9076 35.9114 37.5121 1.10402 -9.8189 16.5264 -671 4 45.0997 33.7597 38.1755 17.1722 -3.36537 -3.11703 -672 4 45.6001 34.3514 39.6854 13.8349 -0.884929 -1.62484 -673 4 47.4022 32.4647 37.9216 2.87405 7.70981 18.3952 -674 4 46.1271 31.862 38.9206 0.553217 -4.0431 12.8995 -675 4 47.6279 33.4362 40.8042 9.43822 -37.2826 -24.9694 -676 4 48.3342 30.5657 38.5603 0.826291 -3.97588 -2.82687 -677 4 49.185 29.675 39.7859 6.04467 -9.07236 4.91997 -678 4 48.5432 32.0104 0.443983 -2.47374 7.53927 7.97734 -679 4 49.3442 30.5519 41.958 17.8055 -32.7958 11.0172 -680 1 49.7507 37.2761 38.36 -27.9891 3.94923 -10.3626 -681 2 50.6372 38.1716 37.6465 6.90802 9.01894 -16.7299 -682 2 51.1009 37.4739 36.3314 6.00851 -0.000986305 0.302592 -683 3 51.4496 36.2941 36.3505 -3.04594 -4.29189 2.8804 -684 4 50.1774 36.6397 39.0138 14.1864 -12.0724 14.4781 -685 4 50.0595 39.0583 37.2837 -1.51256 1.6517 8.14679 -686 2 51.8464 38.6091 38.5553 2.49074 0.426256 -22.3009 -687 2 51.5192 39.49 39.8069 -13.5557 -5.73698 -8.16935 -688 2 52.7888 39.6608 40.6664 -21 22.821 44.9745 -689 2 51.0354 40.8913 39.3667 -19.684 19.0705 -14.0846 -690 4 52.5817 39.1556 37.8894 -7.88883 -2.40182 8.97054 -691 4 52.3725 37.6699 38.8321 2.26719 1.04002 8.03718 -692 4 50.6848 39.0041 40.3963 9.50705 2.70236 -0.692257 -693 4 52.9505 38.8088 41.3668 0.716139 -3.31122 -6.89789 -694 4 52.7117 40.5855 41.3722 -1.5977 -23.2904 -18.3054 -695 4 53.6872 39.819 40.0903 21.6097 1.4026 -14.7648 -696 4 51.7777 41.4333 38.7338 5.73144 0.910017 10.7761 -697 4 50.6933 41.5309 40.2327 12.7628 -5.43827 -4.45399 -698 4 50.1361 40.9136 38.7005 3.06807 -14.6998 5.44273 -699 1 51.1637 38.2069 35.1833 -8.65277 46.2898 44.1617 -700 2 51.553 37.7419 33.8846 1.56046 15.8517 -26.9219 -701 2 52.7972 38.5563 33.3946 6.24297 -42.3048 -4.64985 -702 3 52.8896 39.7642 33.5814 -6.435 17.9384 2.35192 -703 4 50.9569 39.2647 35.262 8.21378 -41.2603 -12.3383 -704 4 51.8027 36.6701 33.8819 4.46523 -10.0245 6.73196 -705 2 50.2986 37.9511 32.9329 -9.17145 -5.64023 18.3882 -706 2 49.0629 37.0889 33.4059 8.5101 -2.50878 -15.0431 -707 2 50.6601 37.6697 31.4816 -9.00198 -6.28682 -34.5666 -708 2 49.2037 35.5513 33.2317 13.0867 -6.63955 11.9256 -709 4 49.9372 39.0006 33.0238 8.27291 6.69816 -3.39278 -710 4 48.1686 37.4323 32.8001 8.11156 -5.69031 9.58675 -711 4 48.8477 37.3684 34.464 -5.28515 -5.82898 -0.156702 -712 4 49.7508 37.5287 30.8047 12.011 -0.0430796 16.0089 -713 4 51.2928 36.7446 31.376 -4.11156 8.47591 0.32382 -714 4 51.1768 38.5507 31.0175 4.51478 -6.96789 5.36543 -715 4 50.1453 35.1216 33.7014 -11.0082 12.206 -5.4516 -716 4 49.2178 35.23 32.1578 -3.59036 3.22922 4.55632 -717 4 48.3665 35.0295 33.7638 0.68062 2.42879 -7.65558 -718 1 53.772 37.8505 32.7005 11.9802 38.3584 -9.99311 -719 2 54.8892 38.4918 31.9453 -18.9337 33.3604 36.4373 -720 2 0.0457823 37.9282 30.5422 -8.24024 2.92716 -24.5162 -721 3 0.594264 36.8423 30.3259 -11.3073 1.50903 5.31397 -722 4 53.7906 36.8495 32.616 -6.44893 -30.0966 2.1434 -723 4 54.5933 39.6185 31.9763 4.67753 -27.1194 -20.6963 -724 2 1.30394 38.4484 32.6241 4.82921 -5.73508 14.5601 -725 2 2.2605 39.423 31.9346 -38.1373 19.2777 23.8899 -726 2 1.83713 40.7771 31.9484 17.1926 2.24265 -1.86924 -727 2 3.4991 39.1266 31.4137 44.2785 -3.28979 -22.8275 -728 2 2.64242 41.8019 31.4282 -29.5168 1.86603 13.0701 -729 2 4.3212 40.1796 30.8558 3.27898 -39.2743 8.81887 -730 2 3.87185 41.4777 30.8782 6.24363 43.3598 -8.15054 -731 4 1.73925 37.4095 32.5315 -6.00214 7.91305 5.68876 -732 4 1.22265 38.7505 33.7444 5.52003 -9.57077 -28.715 -733 4 0.900292 41.0813 32.4345 -2.25415 1.01323 1.36593 -734 4 3.85804 38.0586 31.4239 -1.87041 17.6471 -1.97414 -735 4 2.21075 0.929728 31.5263 16.6224 -11.4708 -8.14622 -736 4 5.34427 40.0148 30.4252 -14.7168 -7.47964 5.81345 -737 4 4.49601 0.410438 30.4759 -4.95559 -13.7664 3.94973 -738 1 54.5157 38.6773 29.5249 -27.0888 35.6462 7.20647 -739 2 54.4663 38.361 28.1069 5.2815 -2.56059 -27.0064 -740 2 53.8105 37.007 27.8285 4.1142 -30.4598 -15.4676 -741 3 54.2925 36.1623 27.0158 -8.84 24.3654 24.6709 -742 4 54.0165 39.6075 29.7175 18.6271 -30.7219 2.56864 -743 4 53.83 39.1099 27.5328 0.819814 -7.88342 20.1611 -744 2 0.845681 38.4599 27.4009 -3.37868 13.1124 0.920574 -745 4 1.3644 39.4179 27.7359 0.635395 -16.0183 -8.53916 -746 4 0.720089 38.4757 26.2839 -0.330424 7.67272 7.0695 -747 4 1.43916 37.5478 27.5772 11.0328 -1.07232 10.5421 -748 1 52.6562 36.7643 28.4919 4.43857 42.1876 29.7882 -749 2 51.8688 35.5726 28.5678 11.3762 10.3615 -9.24037 -750 2 52.1836 34.677 29.7554 -56.6515 -45.7393 26.8579 -751 3 51.2796 33.8674 30.1477 33.9368 21.5747 -13.7315 -752 4 52.2409 37.5914 29.034 7.3769 -32.5773 -16.326 -753 4 50.8037 35.9045 28.6197 0.824464 -11.9292 4.40922 -754 4 51.9818 34.9789 27.6186 -1.74208 2.17118 9.08886 -755 1 53.386 34.609 30.3327 15.9463 0.295407 3.2668 -756 2 53.8702 33.5918 31.2906 -5.336 7.3854 -1.97925 -757 2 53.2724 33.784 32.6972 3.62039 -3.18208 -20.5224 -758 3 53.318 34.8834 33.2435 -3.37109 6.20646 2.08258 -759 4 54.0584 35.341 30.1321 12.3398 9.17802 -3.54281 -760 4 53.5469 32.5903 30.928 0.510164 -2.93777 -2.78072 -761 2 0.450375 33.6574 31.3834 -19.8167 20.6669 9.28695 -762 2 1.1189 33.1041 30.1021 -5.33927 -7.82927 4.13606 -763 2 2.62926 33.3565 30.0201 27.5042 -3.46073 -5.185 -764 2 3.52676 32.4236 30.898 -7.76336 10.6891 3.26174 -765 1 4.93921 32.7908 30.8651 -15.3408 -23.1293 6.29736 -766 4 0.715906 33.1135 32.3077 13.219 -7.49284 0.339296 -767 4 0.711888 34.7596 31.5921 3.25804 -21.2431 -6.20467 -768 4 0.610971 33.6189 29.2485 6.53106 -4.93764 -4.86032 -769 4 0.94328 31.9817 29.9891 -3.372 16.4508 0.497364 -770 4 2.92569 34.3879 30.2717 -10.3735 11.8265 3.32189 -771 4 2.96748 33.277 28.9434 -5.36763 -4.46501 9.75656 -772 4 3.3856 31.3899 30.5364 6.91643 -9.08032 2.48396 -773 4 3.23325 32.4634 31.9813 -4.58699 -1.94284 -9.93441 -774 4 5.35439 32.7181 29.9584 6.30767 5.94328 -10.9381 -775 4 5.52691 32.2429 31.4849 -0.455553 -3.36681 1.56927 -776 4 5.05493 33.7218 31.1915 7.72328 25.1707 0.250012 -777 1 52.7526 32.6794 33.2917 -1.1678 -10.0217 7.16811 -778 2 52.3607 32.6823 34.7156 1.10255 -1.80451 -46.4405 -779 2 53.6298 32.9771 35.466 24.3124 -3.86391 3.03884 -780 3 54.7252 32.4235 35.2212 -23.0397 10.722 4.71956 -781 4 52.6718 31.7771 32.7765 -0.499018 10.5241 3.64804 -782 4 51.648 33.5318 34.8013 -6.43996 -0.39665 8.9378 -783 2 51.7643 31.3153 35.1205 -14.6608 -0.598675 31.299 -784 2 50.4472 31.4454 35.9643 8.77941 -15.5352 -26.1807 -785 2 50.5832 31.9625 37.3651 -2.67912 16.3525 37.5763 -786 3 49.9209 32.9494 37.7433 9.07957 -2.58057 -6.15032 -787 1 51.437 31.3297 38.2211 2.67596 1.57171 0.930055 -788 4 52.5216 30.7277 35.7054 -4.20254 0.0350677 -4.46682 -789 4 51.4878 30.6783 34.2719 3.29993 -4.42069 -15.0162 -790 4 49.9434 30.4567 35.9623 3.78404 -4.63917 10.5702 -791 4 49.6858 32.0412 35.427 2.21977 11.0074 -1.38139 -792 4 51.8063 30.3924 37.9705 2.16328 6.00798 1.3625 -793 4 51.6437 31.7399 39.1747 -6.68696 -10.5036 -22.3596 -794 1 53.5095 33.8962 36.42 -8.20166 25.4414 22.1973 -795 2 54.5747 34.3024 37.3295 -19.3274 -47.2338 19.7644 -796 2 54.3374 33.5175 38.6424 -52.3016 59.5202 -10.0971 -797 3 53.3688 33.7998 39.3891 18.863 -9.21915 -6.06634 -798 4 52.6243 34.4292 36.5865 8.7567 -9.68897 -5.69769 -799 4 0.524888 33.8606 36.995 20.2449 10.0463 -17.6441 -800 2 54.6326 35.7977 37.4305 -12.9517 47.1344 28.5316 -801 2 0.0326923 36.4499 36.0829 -2.43572 -2.53932 -10.8482 -802 2 0.0400304 37.9734 36.2703 -35.7369 26.7596 -9.32276 -803 2 1.42323 35.9178 35.6511 7.48175 21.564 37.2538 -804 4 0.37702 36.205 38.1946 -7.23177 -18.0499 -4.52301 -805 4 53.6103 36.1739 37.8346 22.3749 -7.86488 -15.795 -806 4 54.308 36.1878 35.2646 -5.73883 1.17112 4.65385 -807 4 54.1487 38.389 36.8719 12.989 -15.5349 -14.8375 -808 4 55.0091 38.5546 35.2982 1.66458 -12.2972 11.8538 -809 4 0.898146 38.314 36.8215 26.4509 7.27198 12.604 -810 4 1.38795 34.9003 35.2548 1.76467 -17.1685 3.06812 -811 4 2.15782 36.0461 36.5409 -11.2535 -11.763 -23.0993 -812 4 1.84494 36.4876 34.8385 7.70144 16.3511 -18.9114 -813 1 0.00368541 32.3928 38.6933 60.3495 -72.1401 -12.2197 -814 2 54.849 31.2911 39.6724 -12.054 11.0917 -33.5573 -815 2 0.456178 31.7903 40.9874 10.6429 2.84259 -7.8967 -816 3 1.61925 32.1816 41.0469 -1.25889 2.69502 -0.320895 -817 4 0.771148 32.2113 37.9508 -27.5595 2.34137 31.2634 -818 4 53.7516 31.0568 39.7052 4.35339 2.80588 13.4321 -819 2 0.572301 30.0297 39.0906 18.5839 -9.3637 1.30639 -820 2 0.330271 28.7129 39.848 -4.85336 -14.889 23.6916 -821 2 0.693398 28.6486 41.365 -25.7394 -2.5332 -16.7842 -822 3 54.7394 28.745 0.295995 1.88939 6.38348 7.55667 -823 3 1.88537 28.4667 41.718 12.1129 0.623711 3.73015 -824 4 1.68124 30.2872 39.0755 -12.926 -11.288 -1.20667 -825 4 0.269733 29.7427 38.025 4.32739 20.9521 12.5377 -826 4 0.909417 27.8521 39.409 -5.73579 9.2082 -7.491 -827 4 54.2152 28.4395 39.7334 16.9231 1.48772 2.1114 -828 1 54.6305 31.7883 0.132952 22.8608 6.07746 39.2243 -829 2 54.8576 32.3299 1.48573 -29.3221 31.1311 -21.4901 -830 2 1.17253 32.0229 2.2009 17.6366 -16.111 10.5973 -831 3 1.59057 32.8071 3.07156 -0.674056 0.0659302 -13.788 -832 4 53.659 31.6017 41.9208 -28.5726 -8.3455 -12.917 -833 4 54.8441 33.4787 1.30532 5.06012 -29.8204 14.0187 -834 2 53.6539 32.0394 2.47663 -0.820586 10.1398 -23.6755 -835 2 52.2239 32.3686 2.01123 21.8921 -9.62397 -13.268 -836 3 51.4302 33.0165 2.73635 3.85378 3.64717 10.9914 -837 3 51.8951 32.0293 0.84168 -3.94391 -2.23918 -4.0609 -838 4 53.7898 32.6162 3.39279 8.30271 4.42614 18.4259 -839 4 53.7249 30.9715 2.71423 -6.48233 -12.4206 11.3701 -840 1 1.80027 30.8157 2.00429 -3.41308 17.021 -11.1273 -841 2 3.01391 30.3872 2.67306 -17.4243 6.23421 51.1709 -842 2 4.3573 30.5827 2.00701 -14.1548 15.4243 -63.5733 -843 3 5.42088 30.6338 2.61698 6.51202 -0.211014 15.7475 -844 4 1.38736 30.0831 1.41283 -0.948729 3.54349 -2.60962 -845 4 3.08525 30.9412 3.69277 -1.85342 -9.762 -26.0847 -846 4 2.85031 29.3254 2.98975 11.9317 8.24793 -5.27874 -847 1 4.28888 30.743 0.620497 -12.3621 7.32386 22.4338 -848 2 5.32937 31.2764 41.6512 -13.8663 -29.5394 -9.66616 -849 2 5.57121 32.722 0.10225 -38.3787 16.5244 28.1783 -850 3 4.67744 33.4061 0.685107 26.0808 -18.0695 -15.0621 -851 4 3.36015 30.6914 0.159011 7.3551 0.286523 4.85155 -852 4 6.25759 30.6643 41.7722 1.97617 9.44883 5.82281 -853 2 4.84937 31.1813 40.1487 29.2597 0.863212 8.06821 -854 2 4.69879 29.8019 39.4857 10.4894 -21.0831 -13.1113 -855 2 5.6473 28.6668 39.9936 -13.3021 -14.9024 -16.8737 -856 1 5.27077 28.179 41.3306 -2.96519 4.49812 -11.7353 -857 2 6.06985 28.0105 0.470368 18.4061 -2.74343 27.4639 -858 1 7.404 28.2193 0.415809 -33.9112 -6.97322 0.0250223 -859 1 5.53751 27.6715 1.66745 7.41355 -4.5447 5.6764 -860 4 5.59287 31.7875 39.5584 -6.62026 -5.01092 -0.797873 -861 4 3.90042 31.6963 40.0361 -18.37 16.2558 -2.13315 -862 4 4.87993 29.9347 38.3602 -5.0628 -2.10161 17.6043 -863 4 3.66163 29.4121 39.5629 -5.01534 4.60088 1.06729 -864 4 6.67981 29.0441 39.9161 8.56645 -0.645935 3.00783 -865 4 5.57604 27.7587 39.2774 2.4211 23.1794 17.5601 -866 4 4.26853 28.0084 41.463 -5.17362 0.488763 -0.181308 -867 4 7.82192 28.2777 41.397 19.0269 3.46358 -1.03101 -868 4 7.9555 28.2212 1.28205 9.21585 -1.90571 -0.36079 -869 4 4.50489 27.4888 1.75639 19.7441 2.64647 4.92685 -870 4 6.15841 27.5559 2.53009 -21.7479 0.642981 -21.0512 -871 1 6.76075 33.214 41.6912 19.219 -12.8447 -16.8584 -872 2 7.12868 34.5749 41.8436 1.78261 35.3429 43.0116 -873 2 6.77609 35.3298 40.5962 -19.1975 -45.9981 -46.2181 -874 3 6.48326 34.7082 39.534 6.6414 26.9902 28.4778 -875 4 7.37626 32.7254 41.0127 -5.73863 2.32833 8.30529 -876 4 6.55071 35.0559 0.812315 8.37617 -12.7412 -20.2377 -877 2 8.6392 34.7953 0.238234 19.5739 7.90851 -48.6006 -878 3 9.35353 34.1854 41.0304 -12.8386 -4.95727 8.3137 -879 2 9.11551 34.1669 1.50873 -18.8724 -23.6236 42.9663 -880 4 8.9088 35.8955 0.234805 -6.25165 -9.40588 3.92441 -881 4 10.2786 34.3917 40.988 -0.40493 9.85267 11.4657 -882 4 10.1184 34.4515 1.79035 25.1513 6.04912 0.147779 -883 4 9.07131 33.0605 1.52977 2.37755 -2.72972 -9.56943 -884 4 8.50911 34.4369 2.41136 -0.948376 7.25744 -9.18832 -885 1 6.94474 36.6394 40.6556 -2.44135 26.6434 -23.8261 -886 2 6.9184 37.5467 39.5347 6.69905 -14.1713 -12.8446 -887 2 8.05389 37.1964 38.5245 -27.4859 18.9986 34.7956 -888 3 7.86013 37.2053 37.325 -9.29767 -2.30205 -27.2404 -889 4 7.0965 37.1097 41.5252 4.96112 6.67936 34.6112 -890 4 5.99819 37.3272 38.9586 -4.63141 4.06603 -3.57729 -891 2 6.96111 39.0217 40.0249 7.60343 4.99798 32.9439 -892 2 5.64771 39.5459 40.7503 13.3303 -11.7686 1.87571 -893 2 5.75985 41.0532 41.0609 20.2812 5.99168 -41.4278 -894 2 4.32816 39.2726 39.9704 18.565 3.35099 -29.4893 -895 4 7.21258 39.6788 39.2071 1.58444 12.8598 -26.2647 -896 4 7.87294 39.1662 40.7418 -24.807 -6.41168 -15.2883 -897 4 5.6203 39.0148 41.7319 -7.34537 -3.15131 1.25362 -898 4 4.91646 41.4032 41.6252 -26.0876 7.76092 9.54018 -899 4 5.84653 41.6805 40.0749 -1.44823 -14.0856 28.5036 -900 4 6.60816 41.2866 41.7276 9.52725 -0.69638 -3.08419 -901 4 4.29893 39.8385 38.99 0.215491 -3.12837 12.3269 -902 4 3.42741 39.5069 40.5265 -12.1672 8.54215 8.82184 -903 4 4.17367 38.2217 39.6869 7.24572 -5.84244 0.858739 -904 1 9.22626 36.8637 39.0427 21.4973 3.37181 48.1033 -905 2 10.3674 36.5714 38.2232 -9.10154 -9.23991 0.387697 -906 2 10.2983 35.2598 37.4643 -7.87493 -21.516 -1.82692 -907 3 11.0121 35.0941 36.4546 -10.096 5.18496 3.08952 -908 4 9.43559 37.0753 40.0799 -6.60045 -9.32212 -38.2223 -909 4 10.38 37.3229 37.4195 5.65865 10.6121 -8.5187 -910 2 11.637 36.6734 39.0312 17.5501 -7.37692 6.57672 -911 3 11.6795 35.7227 40.1079 -2.8679 20.1807 -0.19791 -912 4 11.748 37.6704 39.4409 -4.03165 17.0402 13.6797 -913 4 12.5247 36.6276 38.381 6.78129 -14.3562 -2.26856 -914 4 12.1944 34.9922 39.8075 10.5839 -13.8343 -8.97123 -915 1 9.37599 34.317 37.8723 17.0981 22.6825 36.4547 -916 2 9.03961 33.1663 37.0884 -21.5177 -32.5135 -8.8238 -917 2 8.42186 33.6216 35.772 12.1136 -61.8885 -37.6156 -918 3 8.46238 32.81 34.7849 1.32901 29.1307 35.9822 -919 4 8.95542 34.3811 38.853 10.4706 -4.46378 -29.0763 -920 4 9.93142 32.5518 36.7616 2.79547 16.9463 9.21372 -921 2 8.03197 32.1466 37.7484 3.42637 10.6841 -18.9321 -922 2 8.64707 31.2467 38.7916 -6.9544 1.67927 -4.64681 -923 3 8.29676 31.4213 39.9815 6.74685 -6.11142 9.13282 -924 3 9.44706 30.3423 38.4151 3.7337 3.36295 -6.87259 -925 4 7.50152 31.5448 36.9637 8.39997 -2.11551 6.41653 -926 4 7.19405 32.7023 38.1775 -8.25993 10.1263 10.5291 -927 1 7.75009 34.762 35.719 -22.4701 19.7147 -23.1057 -928 2 7.04455 35.3131 34.5484 -10.1936 -29.3849 23.8741 -929 2 7.86233 36.3488 33.8376 -13.0656 11.1044 -41.9487 -930 3 7.58485 36.6599 32.6528 -2.0293 -9.17756 21.4272 -931 4 7.63327 35.3235 36.5488 -2.91413 9.03335 17.0933 -932 4 6.86396 34.4501 33.8456 12.5342 10.3996 -5.08052 -933 2 5.61426 35.844 34.9306 19.6262 -1.52617 -28.8748 -934 2 4.83213 34.6653 35.4025 -10.2806 -24.7237 17.6593 -935 2 4.57558 34.457 36.7787 11.017 23.715 -9.65022 -936 2 4.42364 33.669 34.4835 -0.204454 17.9401 5.69744 -937 2 3.80293 33.3928 37.1817 -18.0339 -16.5573 23.9014 -938 2 3.6203 32.6104 34.8697 -1.59657 -1.57291 16.7967 -939 2 3.28719 32.4878 36.2185 14.3191 25.239 16.785 -940 3 2.42643 31.5967 36.7004 -21.786 -29.0921 6.36516 -941 4 5.08947 36.2348 33.9913 8.47084 3.13833 18.0937 -942 4 5.68856 36.6154 35.7126 -3.45102 11.3715 1.65586 -943 4 4.93536 35.177 37.5545 -2.85956 -5.82375 -8.46254 -944 4 4.68581 33.7849 33.4351 -1.13786 -0.0334624 -10.731 -945 4 3.5508 33.3312 38.3093 3.7661 -3.16504 -32.8067 -946 4 3.21561 31.8879 34.1609 -1.14089 -4.88721 -7.16666 -947 4 2.07822 31.0058 36.0335 4.80509 5.07869 -1.12919 -948 1 8.89276 36.9109 34.4697 3.08208 2.61779 2.42454 -949 2 9.71554 37.9518 33.9536 6.78836 41.9101 -7.41895 -950 2 8.87118 39.1918 33.5791 -2.83098 -3.29658 16.5328 -951 3 9.07345 39.7706 32.5156 6.00915 0.294316 2.75033 -952 4 9.0886 36.6939 35.4314 3.3626 -5.13227 22.9354 -953 4 10.4005 38.393 34.7625 -11.752 -18.5108 -5.62727 -954 2 10.5665 37.5273 32.7526 17.9231 -22.0125 -23.4044 -955 2 11.7038 38.502 32.4536 -20.96 9.74481 -37.2535 -956 3 11.6878 39.1949 31.3977 0.540028 -8.54016 25.273 -957 1 12.687 38.5377 33.3475 38.0496 20.2334 23.5086 -958 4 9.97947 37.4403 31.7814 1.01798 2.165 18.3599 -959 4 11.0193 36.505 32.8955 -2.74071 8.1052 0.988861 -960 4 12.6531 37.864 34.1655 7.32082 17.5294 -13.3715 -961 4 13.4532 39.3055 33.2787 -30.6572 -33.7139 4.421 -962 1 7.93658 39.5767 34.4996 32.6534 -23.6413 -9.43678 -963 2 7.20273 40.8089 34.5743 -2.74612 21.1773 -15.346 -964 2 8.21766 41.8982 34.9197 -3.45605 -13.7782 10.2915 -965 3 8.98784 41.7778 35.8832 -3.40272 -3.46005 -6.10842 -966 4 7.93188 38.9898 35.3424 -7.46187 6.56739 7.86278 -967 4 6.79415 41.087 33.5295 1.97546 -9.26453 20.6229 -968 2 6.06472 40.6271 35.6481 -5.08297 -2.08213 -22.9213 -969 2 4.90833 39.9858 34.8157 -12.6977 -10.7104 -3.72739 -970 2 5.64222 41.9226 36.403 -2.05312 -2.0705 -19.9517 -971 2 3.84054 39.2603 35.6406 -0.0147652 -3.33058 30.6695 -972 4 6.3943 39.8459 36.3734 2.85979 7.06395 10.3389 -973 4 5.33061 39.1839 34.1245 -4.62997 12.2623 4.99778 -974 4 4.37584 40.73 34.1591 8.26763 -2.20969 2.2716 -975 4 4.92993 41.6478 37.2106 -0.0042749 6.0371 4.19307 -976 4 5.15795 0.778755 35.7389 -1.27911 -10.984 2.34352 -977 4 6.51935 0.549814 36.8166 0.412823 -4.00159 10.9885 -978 4 3.21428 39.9846 36.2492 8.55414 -9.22464 -7.99451 -979 4 4.28582 38.4972 36.3757 -6.36125 15.4526 -14.7269 -980 4 3.14756 38.696 34.9847 -1.95473 -0.292674 -1.44435 -981 1 8.25206 1.08297 34.1638 31.3741 38.5442 9.59718 -982 2 9.18814 2.19093 34.4552 -11.7272 -14.356 -0.722089 -983 2 8.45749 3.48131 34.8023 4.76941 7.21795 3.77261 -984 3 7.24176 3.59586 34.6101 4.23254 1.41941 3.46139 -985 4 7.75397 1.25241 33.3001 -16.6469 -12.6897 -14.3012 -986 4 9.75614 1.90919 35.3591 7.11639 4.99627 7.91164 -987 2 10.1452 2.40125 33.2642 -9.36205 3.53781 1.41258 -988 2 11.145 1.26701 33.0621 15.3724 -18.5317 -10.2549 -989 2 12.3408 1.2215 34.0193 -34.6799 -20.8737 -4.25674 -990 3 13.4283 1.6066 33.6334 28.2263 9.73281 -4.88467 -991 1 12.1185 0.540183 35.1633 28.8031 2.35628 29.4382 -992 4 10.7148 3.34616 33.3936 1.59432 0.534457 -2.79864 -993 4 9.49714 2.55965 32.3759 6.01649 -0.268224 -5.10448 -994 4 11.6127 1.34439 32.0577 -0.769775 9.57011 -1.56393 -995 4 10.6933 0.251936 32.9886 -5.52334 3.35231 7.85959 -996 4 11.2139 0.219277 35.5156 -12.526 -0.0546681 -6.86711 -997 4 12.9016 0.455342 35.8573 -9.00019 3.15098 -17.6728 -998 1 9.24699 4.48326 35.2867 7.50516 -22.9453 -9.87373 -999 2 8.79457 5.81029 35.6553 19.4094 -0.44208 23.4194 -1000 2 7.94193 6.35186 34.5098 -28.0836 13.7832 22.6841 -1001 3 8.26577 6.15625 33.3485 3.32417 -1.59684 -17.5239 -1002 4 10.2626 4.25405 35.3107 -8.01304 16.2193 5.9612 -1003 4 8.1894 5.68577 36.5846 -11.6257 -0.00282829 -7.04897 -1004 2 9.97767 6.74716 36.1433 -23.7266 14.1696 -20.2452 -1005 2 11.1395 6.93836 35.1562 2.17384 -4.68321 -25.171 -1006 2 12.442 7.40754 35.8023 6.89417 23.6707 25.6501 -1007 2 12.3585 8.87197 36.3546 -17.7601 7.18701 6.16378 -1008 1 13.652 9.40345 36.7619 -5.05233 -10.0697 25.3038 -1009 4 10.4674 6.41708 37.0624 -6.17454 -12.8958 16.6295 -1010 4 9.46609 7.72624 36.4439 19.6997 -12.4825 -9.52898 -1011 4 10.8586 7.67723 34.3661 -2.31205 -2.27426 2.47252 -1012 4 11.3956 5.98923 34.5935 -8.15618 9.36142 7.97067 -1013 4 13.285 7.3766 35.0989 4.02069 -2.74272 -14.2107 -1014 4 12.7725 6.74228 36.6382 -4.94702 -0.810609 -4.3443 -1015 4 11.6162 8.97546 37.2517 21.5709 -5.37851 -23.6156 -1016 4 11.9848 9.59279 35.5592 1.32622 -13.234 7.43529 -1017 4 13.5097 10.3531 37.0548 1.1249 12.5728 4.15723 -1018 4 14.3076 9.4933 35.9914 2.38442 -5.54985 1.16984 -1019 4 14.0989 8.9471 37.5942 -8.28554 10.0467 -28.7492 -1020 1 6.74258 6.95961 34.8453 13.8439 -7.08515 -31.5666 -1021 2 5.70412 7.47847 33.9372 22.4359 17.1833 28.8896 -1022 2 4.73468 6.47268 33.3926 -37.2702 -51.3286 -21.7325 -1023 3 3.66084 6.82477 32.8505 20.0183 9.28716 8.38675 -1024 4 6.50761 7.12516 35.8163 -0.959582 1.3178 20.8718 -1025 4 5.07512 8.17388 34.5809 1.06569 -12.1955 -8.24357 -1026 2 6.27511 8.35576 32.8097 23.4106 2.51452 -13.5767 -1027 2 6.97942 9.67377 33.2004 -16.9954 14.0421 10.4255 -1028 2 6.10535 10.8129 33.826 12.866 -26.3315 -27.4761 -1029 3 5.32563 11.4369 33.048 -2.57309 4.89094 -0.177716 -1030 3 6.28787 11.1355 35.0235 5.56298 3.82152 16.5631 -1031 4 5.49496 8.55729 32.0786 -16.2509 9.70978 -5.42728 -1032 4 7.00993 7.79082 32.1666 -6.62982 -1.98309 13.432 -1033 4 7.44051 10.1227 32.2823 5.63402 -3.39012 2.91122 -1034 4 7.79617 9.4262 33.9151 4.88029 0.56984 -5.69246 -1035 1 4.9985 5.11713 33.407 24.659 21.8647 21.6253 -1036 2 4.05493 4.11234 32.9569 -19.5991 11.2557 -30.6753 -1037 2 2.66349 4.36425 33.564 5.77052 11.5327 33.941 -1038 3 2.61183 4.63212 34.7889 -10.6254 -2.1096 -24.9185 -1039 4 5.90798 4.72579 33.7623 -18.8375 16.0079 -6.75199 -1040 4 3.94963 4.2178 31.8123 4.18537 -9.18741 21.4869 -1041 2 4.52113 2.73738 33.4375 8.25229 -17.2331 29.0433 -1042 3 5.75234 2.38881 32.7881 -21.5054 -2.62865 -12.7372 -1043 4 3.76903 1.95227 33.2696 -3.85539 -5.9091 -13.5606 -1044 4 4.62925 2.69715 34.589 6.20333 6.93314 -25.3828 -1045 4 6.43526 2.61043 33.3995 7.46021 4.72267 11.925 -1046 1 1.55191 4.21884 32.8032 -14.0425 -5.15851 -21.6842 -1047 2 0.161375 4.25438 33.2368 -9.40026 13.4655 23.096 -1048 2 54.692 2.80115 33.3646 18.1492 -1.83923 -37.1888 -1049 3 54.7885 2.04564 32.3679 -9.76904 2.34815 11.9713 -1050 4 1.58614 3.87283 31.8209 11.2241 6.42129 12.946 -1051 4 0.0932821 4.78062 34.2407 6.57702 -9.00044 -6.29593 -1052 2 54.1421 5.03026 32.3092 -30.8516 -27.3257 32.8914 -1053 3 54.4529 6.38645 32.3432 43.6526 11.7784 12.1317 -1054 2 52.6693 5.00292 32.8811 18.0931 2.75777 -15.9968 -1055 4 54.1554 4.62002 31.3044 4.18983 -2.87474 -22.2473 -1056 4 53.8639 6.90955 31.8518 -25.2917 13.9269 -18.693 -1057 4 52.66 5.46781 33.8932 -7.48107 5.39969 -2.18241 -1058 4 52.249 3.98991 33.0062 0.231344 -5.48034 -3.27193 -1059 4 51.9963 5.5356 32.1423 1.66512 -1.40627 14.088 -1060 1 54.1705 2.41097 34.5199 1.80418 26.5965 31.5441 -1061 2 53.4771 1.1604 34.7223 -23.5881 -17.4143 30.2256 -1062 2 51.9672 1.43692 34.4286 45.4706 11.6959 19.6168 -1063 3 51.5098 2.51334 34.8139 -14.0548 -1.70012 -4.22959 -1064 4 54.1449 3.13072 35.3168 -2.84084 -28.6208 -21.3152 -1065 4 53.8073 0.317305 34.0552 7.54144 10.0832 -0.542806 -1066 2 53.6466 0.727247 36.2732 15.0023 -0.977243 -19.0787 -1067 2 0.11045 0.778115 36.8855 -3.47233 23.3808 -12.4462 -1068 2 0.174657 0.0352411 38.2454 9.71436 -6.65086 -1.81426 -1069 2 1.19132 0.222888 35.8995 6.11034 15.7938 3.95568 -1070 4 53.2393 41.6189 36.352 -4.11551 -11.0062 3.39296 -1071 4 53.0266 1.35722 36.9407 -10.5209 2.31976 -3.99924 -1072 4 0.276909 1.89779 37.0745 11.3679 -17.77 -1.06189 -1073 4 54.361 0.442618 38.9125 4.10216 -8.97134 2.26246 -1074 4 1.16474 0.174268 38.7716 -10.2453 4.64912 -5.91146 -1075 4 0.0894693 40.827 38.1128 -8.07449 10.5575 2.47406 -1076 4 2.18017 0.0911741 36.3628 0.498668 -8.86502 15.8712 -1077 4 1.51082 0.946112 35.1046 -21.6742 -5.82018 -4.77892 -1078 4 0.87048 41.1455 35.5035 3.84873 -0.316194 -7.96637 -1079 1 51.2572 0.510776 33.7869 -35.0849 -22.21 -18.422 -1080 2 49.7991 0.651464 33.5457 -7.89552 -1.42073 2.85742 -1081 2 49.1064 41.7127 34.6422 20.8091 24.7993 -30.4476 -1082 3 49.3211 40.5176 34.6928 0.936017 -16.9834 6.81615 -1083 4 51.5685 41.4333 33.6514 6.90564 11.6478 3.53197 -1084 4 49.4699 1.73569 33.6536 7.71362 -9.58165 1.5915 -1085 2 49.2914 0.124722 32.1435 -1.6477 0.542595 21.3952 -1086 2 49.5957 1.07684 31.016 -40.6033 -15.585 26.437 -1087 1 48.7294 1.99918 30.4836 -27.6566 13.4748 -4.54446 -1088 2 50.7297 1.21695 30.3262 36.7247 10.1326 -33.1818 -1089 2 49.2902 2.59089 29.4013 15.6758 12.8861 -16.3634 -1090 1 50.5605 2.13547 29.3267 -27.6128 -3.77706 23.4645 -1091 4 48.1729 41.8384 32.2733 14.3125 6.04861 -12.1255 -1092 4 49.7214 41.0254 31.9181 -0.443629 4.48635 2.11286 -1093 4 47.7408 2.2006 30.8029 20.1006 -6.4749 -2.25561 -1094 4 51.6449 0.698065 30.4056 15.084 -12.5894 5.57169 -1095 4 48.9104 3.2954 28.6425 -5.47018 -10.6135 19.6435 -1096 4 51.2563 2.40703 28.6421 12.9903 7.46191 -13.5301 -1097 1 48.3611 0.457254 35.523 -13.4783 35.8963 4.98689 -1098 2 47.6684 41.7265 36.6028 -12.609 2.82517 16.7739 -1099 2 46.2613 41.336 36.1362 14.2498 9.86212 -6.63619 -1100 3 45.3696 0.249228 35.9008 11.2544 -8.11188 8.40093 -1101 4 48.1527 1.47601 35.3837 2.04907 -15.0615 5.33592 -1102 4 48.2568 40.8085 36.8471 -2.89667 -2.02658 5.80089 -1103 2 47.5596 0.692305 37.8969 5.07609 12.8861 -15.4572 -1104 2 46.7247 0.067171 39.0652 -23.3887 -7.36646 -24.3057 -1105 2 47.033 40.4837 39.4166 -14.2982 16.8046 -18.6717 -1106 2 46.9311 0.907751 40.3269 20.2628 20.9695 31.7148 -1107 4 47.0803 1.72619 37.5586 18.4264 -28.4903 17.3716 -1108 4 48.6288 0.838001 38.2574 -15.841 5.68773 -4.62102 -1109 4 45.6307 0.107149 38.6982 15.4635 0.946246 17.2142 -1110 4 48.0197 40.3992 39.8616 17.8935 -6.94949 10.1905 -1111 4 47.0012 39.8155 38.524 1.84183 3.03864 3.36861 -1112 4 46.2605 40.0937 40.1174 3.5183 -0.242765 2.2201 -1113 4 48.0596 1.05972 40.5786 -27.9597 -7.64804 -5.61245 -1114 4 46.4366 0.492644 41.2461 4.13191 -4.52617 -8.48469 -1115 4 46.5029 1.93558 40.2678 1.33797 -2.98423 -8.86627 -1116 1 46.1363 40.0225 35.9719 -11.8784 -48.163 0.632693 -1117 2 44.9067 39.2611 35.7716 22.3959 0.0668878 -14.2888 -1118 2 44.4049 38.8629 37.1725 -35.2322 11.6067 -22.5418 -1119 3 45.1472 38.486 38.0617 14.0918 -2.68919 9.70234 -1120 4 46.908 39.3425 36.1226 1.34088 13.782 2.29065 -1121 4 44.2497 39.8817 35.1331 -17.245 4.97255 12.4072 -1122 2 45.2366 37.985 34.8925 -4.99104 -6.23114 -9.17669 -1123 2 44.0069 37.0072 34.8313 5.26574 11.342 7.98842 -1124 2 45.6195 38.3915 33.4226 -3.76358 -20.0352 6.70883 -1125 4 46.1177 37.4383 35.3134 -3.76426 -1.15462 7.05426 -1126 4 43.5316 36.9313 35.8696 0.358942 -6.34703 -24.4349 -1127 4 44.3242 35.9956 34.5249 4.20531 -7.16171 2.34616 -1128 4 43.2753 37.3126 34.0403 -3.87397 3.42825 10.5933 -1129 4 46.6384 38.8467 33.4221 -3.79452 2.69366 -2.61982 -1130 4 44.9004 39.1304 33.0043 0.823619 -0.608417 -3.73086 -1131 4 45.6564 37.4663 32.7381 0.0287792 19.4258 11.3413 -1132 1 43.0561 38.9062 37.36 16.7964 -0.846157 38.4014 -1133 2 42.4272 38.5172 38.6279 -14.5421 -18.7427 13.0828 -1134 2 41.8753 37.0763 38.5124 -8.78692 12.5845 -64.2445 -1135 3 41.466 36.6885 37.3717 6.29707 6.96761 32.6735 -1136 4 42.3774 39.0214 36.6331 -15.2734 7.16413 -28.2079 -1137 4 43.1919 38.4467 39.4108 16.1917 0.0561369 8.47296 -1138 2 41.3404 39.5151 39.1514 -18.2527 2.1619 5.40726 -1139 2 42.0205 40.8503 39.6333 -29.5812 13.2835 -20.5362 -1140 2 41.0689 0.171231 39.4112 30.2059 17.4331 -9.29433 -1141 2 42.4678 40.816 41.1078 15.9246 -23.8206 -10.1516 -1142 4 40.688 39.0893 39.9799 16.7303 0.907162 -6.07322 -1143 4 40.5588 39.6983 38.3606 15.4269 0.857054 0.728379 -1144 4 42.8535 41.0549 38.9416 17.5291 -0.3509 1.61726 -1145 4 41.6271 1.1561 39.6676 -14.9721 -22.7636 -0.520954 -1146 4 40.1564 0.111331 40.0029 -13.6089 -0.269988 10.9836 -1147 4 40.76 0.320829 38.3386 1.94315 -8.64923 8.74761 -1148 4 41.6626 40.4848 41.7802 -9.99726 5.60483 6.07701 -1149 4 42.8258 41.8281 41.4135 4.90552 -5.57863 6.49728 -1150 4 43.2679 40.0127 41.241 -4.54696 19.1865 -0.92221 -1151 1 41.8233 36.2733 39.5754 -3.61756 -11.0936 16.9633 -1152 2 41.1922 34.957 39.6399 -10.4088 -17.6704 -50.7121 -1153 2 39.8412 35.0841 40.3193 -0.437683 4.39576 10.763 -1154 3 39.8144 35.4746 41.4864 -9.76 5.96233 -2.547 -1155 4 42.2323 36.5766 40.4577 6.86651 4.46574 10.4638 -1156 4 40.9934 34.6386 38.4963 8.65196 -1.15376 42.0164 -1157 2 42.0562 33.8903 40.4247 20.8855 33.0106 -9.02378 -1158 2 41.3005 32.6543 41 38.0556 15.2529 -12.1112 -1159 2 42.2217 31.3951 41.1067 -29.8496 -30.3433 -13.4218 -1160 1 43.3285 31.549 0.111927 13.7517 39.8644 23.5527 -1161 2 44.3839 30.7268 0.286736 21.6234 19.2182 17.9174 -1162 1 44.681 29.6113 41.5428 -25.8767 -16.3024 -25.7307 -1163 1 45.3493 31.1499 1.13058 -39.3833 23.49 -6.35183 -1164 4 42.617 34.5166 41.192 -12.3652 -23.3828 3.531 -1165 4 42.8948 33.5841 39.7601 -4.64767 -6.80459 -5.17496 -1166 4 40.4819 32.4474 40.3056 -13.8786 -11.9041 -4.8646 -1167 4 40.8645 32.9834 0.0421702 -8.7777 -8.2778 13.4879 -1168 4 42.5872 31.067 40.0872 -0.36901 12.0823 9.30135 -1169 4 41.553 30.5032 41.4129 16.6518 20.7036 2.18161 -1170 4 43.3615 32.497 0.627799 -1.11121 -36.4642 -14.6418 -1171 4 44.0326 29.3067 40.7749 11.9664 -0.606259 12.9296 -1172 4 45.4908 28.9966 41.7635 -4.5997 7.04477 0.652143 -1173 4 45.2947 32.0222 1.6989 -3.32167 -9.1207 -8.17541 -1174 4 46.1369 30.5772 1.3332 29.28 -20.6173 7.21336 -1175 1 38.7318 34.7203 39.6307 -5.56998 -4.40152 -32.2775 -1176 2 37.3555 34.7738 40.1542 17.1032 1.0045 -6.37855 -1177 2 37.2353 33.667 41.1913 -33.3614 37.0741 40.0449 -1178 3 37.7005 32.5636 40.9891 18.731 -32.0974 -3.65368 -1179 4 38.8335 34.3404 38.6486 -6.51334 12.5121 23.5529 -1180 4 37.2672 35.7762 40.6273 -9.086 1.46109 5.84779 -1181 2 36.2453 34.5638 39.0845 -6.93832 -9.37108 -7.97374 -1182 2 36.1701 35.614 37.9414 8.91404 15.2365 -6.3275 -1183 2 35.3527 35.0344 36.7472 39.8054 8.21108 -27.9 -1184 2 35.4841 36.9314 38.4139 -18.287 13.7727 -16.8718 -1185 4 35.232 34.5024 39.5744 7.45292 -0.257102 0.0904576 -1186 4 36.3852 33.5433 38.6164 0.781265 7.17557 6.89015 -1187 4 37.2115 35.9047 37.5843 -11.2451 -10.8797 5.10717 -1188 4 35.5662 35.6385 35.778 -16.1675 -5.48794 25.897 -1189 4 34.291 34.967 37.0013 -15.7304 -0.876038 -4.35202 -1190 4 35.7074 34.0135 36.4456 -4.10332 3.28733 9.08934 -1191 4 35.4655 37.7439 37.5577 -4.97646 -27.0735 23.6494 -1192 4 36.0148 37.4196 39.237 12.1669 1.46201 8.99598 -1193 4 34.4369 36.7462 38.8365 16.8945 3.16641 -16.172 -1194 1 36.5334 33.9935 0.435925 10.1465 7.38421 -15.9691 -1195 2 36.4058 33.2568 1.6875 16.4821 -29.3274 -13.0782 -1196 2 35.1468 33.6833 2.42741 -3.52585 26.4938 2.22063 -1197 3 34.7699 34.8785 2.50349 9.50092 -20.8144 -9.83338 -1198 4 35.9506 34.8486 0.439937 7.33038 -6.12466 -5.51472 -1199 4 36.3499 32.1247 1.42412 1.62075 26.2077 7.36918 -1200 2 37.675 33.5505 2.58336 -0.681506 -6.35683 7.58589 -1201 2 37.7854 32.6927 3.8625 18.6921 -17.668 32.0141 -1202 2 39.0575 32.9332 4.76873 14.2724 -20.5826 -30.9069 -1203 1 39.1289 34.2491 5.33109 11.0713 19.2422 13.5273 -1204 2 40.0441 34.6938 6.2528 -38.5124 5.77538 -21.346 -1205 1 41.0523 34.0015 6.75388 -9.3068 -30.315 -40.8639 -1206 1 39.7573 35.8959 6.75045 4.65044 -37.6482 -19.533 -1207 4 37.7117 34.6025 2.94212 -4.78803 6.98284 -11.1897 -1208 4 38.6033 33.3783 1.98429 -1.50456 2.19712 -0.683264 -1209 4 37.8193 31.5994 3.65006 -4.42508 0.799529 -11.9295 -1210 4 36.9318 32.7949 4.56147 -11.5542 5.52665 -5.70323 -1211 4 39.9727 32.6563 4.13477 -10.3426 12.9457 13.0222 -1212 4 39.0991 32.232 5.62646 -6.41615 -9.9444 -1.6393 -1213 4 38.3112 34.8566 5.12728 9.08197 -0.1797 3.06874 -1214 4 41.338 33.0965 6.26824 1.29043 26.2885 21.8424 -1215 4 41.5567 34.3995 7.53172 18.6054 -2.34736 15.9895 -1216 4 38.9283 36.4191 6.51463 -17.6749 8.57537 -7.4588 -1217 4 40.3535 36.2619 7.44459 24.2502 25.7988 36.1589 -1218 1 34.4423 32.7029 2.99518 -5.91218 -18.2551 8.17758 -1219 2 33.2643 32.9205 3.78866 2.14491 3.18155 15.0212 -1220 2 32.3114 31.74 3.93685 27.6029 1.93064 -50.2862 -1221 3 31.6521 31.6162 4.95167 -20.1995 -6.42992 23.3772 -1222 4 34.7506 31.7123 2.9878 2.11082 4.57648 -1.08475 -1223 4 33.5885 33.2179 4.82725 -4.56531 -3.45872 -11.3922 -1224 4 32.6993 33.791 3.40271 -6.19117 1.50996 -1.33542 -1225 1 32.2733 30.8792 2.86255 -3.44833 -0.807911 26.2314 -1226 2 31.5067 29.6456 2.87911 -22.6819 -12.0155 6.38652 -1227 2 32.0275 28.5204 1.99364 -17.4826 -15.7648 -26.1521 -1228 3 31.24 27.9052 1.1757 18.2868 13.9435 17.0259 -1229 4 32.9257 31.0189 2.07167 -6.99587 -10.4877 -2.31778 -1230 4 31.4409 29.1882 3.92659 1.7726 14.0477 -11.6562 -1231 4 30.4172 29.8482 2.57519 20.7941 0.876843 7.98191 -1232 3 33.2432 28.1769 2.02662 6.75216 10.2675 5.6015 -1233 6 29.6689 33.0345 2.6027 6.39732 3.7635 -6.59735 -1234 4 28.7656 33.0857 2.95028 -0.371973 -14.4593 -6.85361 -1235 4 29.8153 32.1814 2.14015 -8.59972 11.6466 4.8732 -1236 6 1.91326 24.7635 28.0772 5.65317 -6.35183 16.4854 -1237 4 1.01929 24.4316 28.2568 3.94453 1.46201 -0.938269 -1238 4 2.46517 24.4471 28.8255 -6.59296 2.11781 -11.8027 -1239 6 8.98979 35.4216 7.06427 2.13264 0.908259 -3.07356 -1240 4 8.22375 36.0041 6.95701 -0.608539 -3.26387 0.365744 -1241 4 9.74616 35.991 6.87666 4.70766 2.91314 -0.442423 -1242 6 37.9357 35.2342 23.5273 -23.102 9.18642 19.8247 -1243 4 37.5041 35.2968 22.6705 0.513901 -3.82007 -8.89977 -1244 4 38.8432 35.0218 23.4038 20.8563 -8.17935 -11.4372 -1245 6 11.3793 34.6137 20.3253 14.1507 4.32837 -4.20952 -1246 4 10.4755 34.624 20.6003 -22.0831 6.77293 1.73618 -1247 4 11.7264 33.9016 20.8561 13.9299 -11.0914 4.04985 -1248 6 3.06607 13.1144 13.5167 22.577 18.8722 18.6067 -1249 4 2.20388 12.8262 13.8046 -7.02328 -4.57126 0.810516 -1250 4 3.32154 13.8092 14.1761 -2.44089 -14.0351 -15.8923 -1251 6 9.17443 22.3777 24.8954 -7.42914 3.56866 8.74917 -1252 4 9.07626 22.0242 24.0039 2.26474 -2.4656 -3.7019 -1253 4 8.26912 22.4958 25.2295 3.15193 -1.43545 -3.27774 -1254 6 31.1464 36.1236 7.45234 10.6607 -18.1227 -24.2194 -1255 4 30.9334 35.2222 7.12747 -5.34615 12.6105 12.538 -1256 4 31.8314 36.3443 6.79825 -5.43643 8.62165 8.26122 -1257 6 20.3227 0.172698 30.1419 10.3105 -3.05703 7.76208 -1258 4 20.0388 1.0684 29.8874 5.3247 -3.32009 0.781739 -1259 4 21.2583 0.228399 30.4322 -11.2768 6.47679 -5.28094 -1260 6 32.6859 3.01778 5.15829 -10.6028 -19.0303 43.6625 -1261 4 32.0356 2.3058 5.02019 7.54008 9.83835 -8.28794 -1262 4 32.7128 3.00557 6.15578 5.12118 6.62375 -23.7252 -1263 6 26.2374 8.27856 11.5971 17.869 0.788073 20.0593 -1264 4 26.2346 7.39991 12.0216 -0.142457 7.42091 -4.28305 -1265 4 26.8978 8.79254 12.1302 -17.5189 -15.6641 -18.5798 -1266 6 1.09614 20.2561 0.875192 -22.9747 0.467748 19.1373 -1267 4 0.851949 19.3199 1.10255 19.4844 20.3298 -11.3195 -1268 4 1.85437 20.3448 0.297385 12.1513 -16.76 -9.59627 -1269 6 29.1514 22.9126 1.42851 -3.57267 15.5796 12.2113 -1270 4 28.6966 23.7416 1.67141 5.52941 -12.1705 -9.88265 -1271 4 29.6634 22.7027 2.22543 0.165437 -2.26551 -2.85175 -1272 6 34.1399 34.826 6.47271 -4.00425 12.5535 -7.93856 -1273 4 34.8635 34.3401 6.10458 13.259 -3.54932 -9.87122 -1274 4 33.9387 34.3337 7.25184 -8.28913 -2.66912 16.7304 -1275 6 25.1643 37.1931 26.5228 17.2229 -22.0393 -23.1844 -1276 4 24.6935 37.7676 27.1042 -4.31343 22.2846 18.4719 -1277 4 26.0117 37.6203 26.271 -7.79876 5.52479 6.28113 -1278 6 14.5333 22.2337 15.6719 -21.8235 -40.5779 4.16881 -1279 4 14.0435 21.3187 15.7268 23.5152 50.9834 -4.51283 -1280 4 14.2451 22.7392 14.8947 -1.224 -10.8945 3.63574 -1281 6 2.86145 5.86342 4.09514 -12.0928 12.5672 -7.55007 -1282 4 3.31871 5.53612 4.87755 -0.114002 3.3263 11.1441 -1283 4 2.36891 6.69134 4.30817 11.5092 -15.7361 4.93451 -1284 6 27.6072 26.7133 22.7037 11.3111 -21.4893 35.9413 -1285 4 26.8221 26.1673 22.7712 -7.10606 -4.70529 -2.97044 -1286 4 27.5145 27.2572 21.9514 -10.0855 20.8317 -32.7258 -1287 6 17.7799 0.609907 22.4001 -5.17757 10.6635 4.04288 -1288 4 17.0763 0.657064 23.0885 11.5181 4.04392 -9.91171 -1289 4 18.0806 1.5364 22.261 -7.85301 -10.5281 2.59652 -1290 6 8.08893 9.42761 10.5595 3.55537 5.25916 40.324 -1291 4 7.89361 10.322 10.3179 -9.19974 15.7377 -19.3495 -1292 4 8.16563 9.56196 11.5399 2.2102 -21.2534 -20.7584 -1293 6 15.3508 8.71886 30.755 5.09068 -14.416 21.7005 -1294 4 15.721 8.98141 29.9127 -5.17651 10.4904 -11.2194 -1295 4 14.5411 9.19598 30.997 6.64715 3.62724 -9.30987 -1296 6 11.0273 17.2714 37.5546 -8.62993 4.63856 -3.16721 -1297 4 10.646 18.1523 37.5049 13.3861 11.3255 -4.88271 -1298 4 10.2437 16.8378 37.8681 -2.55755 -24.0409 7.53141 -1299 6 42.0954 25.1585 20.3881 14.6842 1.84925 -24.6227 -1300 4 41.6997 25.8318 19.7943 -2.16553 -3.48259 16.6789 -1301 4 41.6994 25.1952 21.2528 -9.02961 7.39914 10.888 -1302 6 25.8656 4.70522 33.8434 4.94337 -17.9304 30.0995 -1303 4 25.7948 4.41246 32.9437 -1.56424 4.53154 -20.9619 -1304 4 25.7821 5.65919 33.9019 -2.93726 10.638 -9.31877 -1305 6 28.7565 10.7943 24.343 5.31048 -5.66707 -17.5237 -1306 4 29.0395 10.691 25.2776 6.61806 -8.7001 -20.887 -1307 4 29.3174 10.2678 23.7025 -8.86987 6.64124 26.5787 -1308 6 5.00601 41.813 11.1 6.11697 -35.3303 28.6791 -1309 4 5.97939 41.6679 11.0741 -12.7816 8.03831 -2.02432 -1310 4 4.68345 41.1078 11.7429 5.5471 25.1349 -25.8779 -1311 6 51.7607 12.785 30.1531 41.9873 7.8243 6.58168 -1312 4 51.5044 13.1989 29.3224 -3.76645 3.26875 -7.63234 -1313 4 52.7548 12.9452 30.2104 -29.821 -7.22149 1.35463 -1314 6 7.60527 6.19156 6.53697 16.5093 0.883216 -0.386471 -1315 4 6.7728 6.50088 6.91441 -4.77803 -9.70632 -1.71599 -1316 4 7.48617 5.31021 6.15237 -11.2115 3.19853 1.4886 -1317 6 14.6639 26.9856 30.1439 5.75321 15.8705 11.2484 -1318 4 14.5566 27.0259 31.1175 -3.12227 -7.05885 -13.9758 -1319 4 15.1715 27.7926 29.9326 -6.11328 -7.83436 0.701957 -1320 6 15.3386 3.73742 21.1629 -49.5233 -4.42818 1.41573 -1321 4 14.7513 4.15862 21.8308 22.5595 -2.74077 -5.2282 -1322 4 14.679 3.20837 20.6508 28.7222 9.19721 3.95726 -1323 6 18.6168 30.4391 6.46727 22.6827 -23.6706 30.2016 -1324 4 19.0357 29.7477 7.08277 -19.2097 26.0479 -21.7287 -1325 4 19.3376 31.0911 6.37388 -10.7119 -2.89972 -1.77141 -1326 6 40.7683 1.30949 12.8061 -7.58564 4.37034 -9.51004 -1327 4 39.8743 1.70123 12.8539 8.02325 -2.8267 0.614513 -1328 4 41.1302 1.62292 11.9594 1.79027 -4.37486 1.66609 -1329 6 17.747 20.7401 41.5828 -14.5708 23.9699 -22.25 -1330 4 16.8287 21.1121 41.5273 18.852 -12.8662 8.2158 -1331 4 18.269 21.3043 40.983 -0.296974 -7.34806 11.4382 -1332 6 20.4522 2.1467 12.3338 -13.8993 16.4183 -18.7538 -1333 4 19.8428 1.38545 12.4588 7.32118 14.6694 -7.56396 -1334 4 20.1591 2.61844 11.4836 4.96023 -26.6086 29.2353 -1335 6 9.8437 37.1731 18.0697 32.5344 -3.69518 -7.02483 -1336 4 9.9915 37.607 18.9153 -11.6933 2.16478 7.61773 -1337 4 10.7629 37.1686 17.7045 -22.2666 -4.61022 -1.39483 -1338 6 22.8273 7.39987 18.8956 -5.5011 7.28813 -36.492 -1339 4 23.2632 7.84344 18.1165 -7.98371 -8.25387 20.5209 -1340 4 21.8866 7.2843 18.6392 14.3432 0.686453 4.84686 -1341 6 12.8601 6.85899 39.0577 6.92589 -13.3495 -12.6124 -1342 4 12.2887 7.60854 39.1608 -14.8411 14.7282 0.271429 -1343 4 13.3423 6.79713 39.8797 5.00888 -0.905409 12.2129 -1344 6 10.1643 2.40912 23.2548 -13.4149 21.1074 -1.06732 -1345 4 10.2774 2.03439 22.3894 8.18098 -13.9841 -15.6202 -1346 4 9.49692 3.09648 23.049 6.99386 -4.39158 13.7206 -1347 6 12.5495 20.2147 19.5723 7.26787 8.21028 -18.3895 -1348 4 11.6895 19.7983 19.735 -1.5185 0.18686 -8.43892 -1349 4 12.6119 20.404 18.6017 -2.05058 -6.51038 26.2392 -1350 6 53.8702 6.35891 18.9198 29.7306 -6.18586 8.10346 -1351 4 53.0457 6.06715 19.2818 -21.258 -2.7468 0.110915 -1352 4 54.4788 6.08079 19.6257 -1.29631 10.1734 -11.3531 -1353 6 1.76233 4.00968 13.2412 15.2049 -20.178 -6.82767 -1354 4 1.1126 4.5015 13.7221 -14.7745 7.27862 5.55391 -1355 4 1.46634 3.0803 13.3195 6.22895 8.64986 -3.00031 -1356 6 2.68809 16.4658 4.58471 15.0105 -8.44828 17.4213 -1357 4 3.47968 16.3912 5.17607 -18.0483 5.65918 -16.5792 -1358 4 2.952 17.0668 3.88721 1.61121 4.43717 -9.18758 -1359 6 22.6412 7.38905 35.0491 -42.342 -19.7774 -51.2585 -1360 4 21.8701 7.10292 34.411 47.7649 22.3984 34.2121 -1361 4 22.4927 6.7758 35.7601 0.300803 -9.30322 17.5195 -1362 6 30.6449 27.8966 19.9 11.2186 24.5725 -17.4668 -1363 4 31.067 28.6028 19.3405 -15.311 -24.4133 12.7333 -1364 4 30.0502 27.364 19.3383 6.18265 4.0422 4.40167 -1365 6 18.3584 9.54031 6.21119 11.0026 -3.68808 23.2716 -1366 4 18.3645 9.12256 5.3612 -2.33489 -5.22153 -19.3682 -1367 4 19.1216 9.13552 6.66909 -8.40358 6.03455 -2.63927 -1368 6 21.0207 30.3946 30.8361 -20.2261 -14.3153 8.76877 -1369 4 21.7305 31.0371 30.8947 0.539155 4.23503 10.2216 -1370 4 20.6128 30.1908 31.727 18.9681 11.2591 -24.4987 -1371 6 28.3223 4.36971 15.0862 0.785553 22.566 1.53388 -1372 4 27.9162 3.53142 15.2341 -13.4814 -22.4749 6.99245 -1373 4 29.0547 4.16931 14.5133 14.7433 -0.183871 -4.75122 -1374 6 12.7699 0.652736 16.5284 -10.9622 36.0111 -3.70833 -1375 4 13.1417 1.43405 17.0195 -7.22472 -23.339 -11.6266 -1376 4 12.1312 1.03058 15.8629 17.1298 -5.78525 17.4901 -1377 6 27.5613 35.204 8.24204 -17.5468 -3.17574 2.50179 -1378 4 28.0037 35.3359 7.41158 3.58667 2.22765 -10.9792 -1379 4 26.8513 34.5538 8.04841 12.0719 12.2779 8.55847 -1380 6 24.0727 5.16129 41.0114 25.3265 34.0312 4.62534 -1381 4 24.5764 6.00631 41.0278 8.83913 -22.6202 16.662 -1382 4 23.4512 5.41721 40.3589 -27.9927 -11.5371 -21.4854 -1383 6 16.8577 24.9409 28.3044 -13.362 20.9446 -8.34262 -1384 4 15.8529 24.9248 28.4711 42.0709 9.51562 -15.4474 -1385 4 17.0929 25.6637 27.6385 -20.1406 -20.6283 22.1367 -1386 6 20.8367 12.7872 17.016 48.1357 -13.7972 -0.957512 -1387 4 20.9831 13.7012 17.3244 -4.24853 -6.44611 -2.53838 -1388 4 21.7731 12.3998 16.8344 -46.2893 13.5674 8.59046 -1389 6 35.7698 23.0286 30.9167 1.31549 -8.15919 10.0357 -1390 4 34.8007 23.0783 30.9694 4.38358 -0.634017 0.107585 -1391 4 36.0504 22.6611 31.7855 -2.79806 7.45108 -14.1947 -1392 6 36.3049 21.4 25.8723 16.8231 15.2703 -10.059 -1393 4 35.3849 21.2313 25.7163 -23.5769 -6.11261 -4.10927 -1394 4 36.6855 20.6326 26.2849 5.24534 -13.4215 6.45433 -1395 6 13.4896 6.74946 5.28081 -28.3592 57.2786 25.4238 -1396 4 13.8414 6.02988 4.86679 44.4058 -71.9847 -33.7479 -1397 4 12.7199 6.9047 4.75258 -19.8414 9.95147 -1.72496 -1398 6 20.8046 20.4221 13.7595 5.24729 11.8597 -23.4966 -1399 4 21.3314 20.3763 14.5586 1.04488 -1.4591 8.76088 -1400 4 19.8874 20.2651 13.9627 -8.54986 -4.70556 7.47732 -1401 6 20.3763 29.1306 1.39291 -22.654 9.61717 24.1604 -1402 4 20.4714 29.8874 2.01179 2.99602 -8.49852 -9.62387 -1403 4 19.4639 28.7985 1.61052 22.0838 3.18086 -13.1329 -1404 6 50.878 13.1268 37.2744 -6.92527 18.9089 19.2141 -1405 4 51.431 12.5903 37.8743 -5.40112 9.96959 -2.47836 -1406 4 50.5327 13.8902 37.8162 10.8793 -23.2499 -13.6212 -1407 6 33.933 34.1706 20.4988 -24.935 23.2996 -4.02345 -1408 4 33.9537 34.3969 19.5503 3.97405 -5.2202 10.173 -1409 4 33.1424 34.6907 20.8306 20.6842 -17.0796 -4.50693 -1410 6 26.2139 28.0427 27.5441 -18.3219 -6.87449 2.92541 -1411 4 26.6233 28.4264 28.3298 2.52406 0.509022 -5.28732 -1412 4 25.2474 28.0355 27.7473 15.6982 -2.70826 -9.65401 -1413 6 7.68199 21.3044 4.2899 -23.4352 7.97399 30.3744 -1414 4 8.39223 20.9571 3.80392 40.3202 -21.1106 -20.5498 -1415 4 7.23721 21.8696 3.67656 -12.7303 12.1883 -10.427 -1416 6 21.997 15.1678 5.91921 0.156106 10.1967 -8.47357 -1417 4 22.4631 15.3078 5.09012 1.49736 10.8302 -2.43488 -1418 4 21.9323 14.2285 5.99467 -4.63281 -19.7734 10.7123 -1419 6 21.7161 24.0028 3.81129 14.7157 -6.77156 -2.79544 -1420 4 22.6514 24.278 3.99089 -16.266 -7.57571 -5.80044 -1421 4 21.7278 23.1773 3.27349 4.3704 10.7286 8.25651 -1422 6 11.5654 23.7677 12.5675 4.34126 23.9889 5.0328 -1423 4 11.8179 24.711 12.3772 -5.51197 -27.812 -0.203907 -1424 4 11.194 23.7871 13.4529 -2.51135 -1.17837 2.27349 -1425 6 32.365 18.0609 29.8133 5.42876 1.07285 10.0727 -1426 4 33.2855 17.8495 29.9872 2.18588 2.92383 8.75228 -1427 4 32.2516 17.686 28.9464 -9.45666 -7.03173 -17.6671 -1428 6 9.26057 12.3901 30.3108 6.69251 -5.93803 -6.45383 -1429 4 8.9331 13.0089 30.9751 -1.99931 -0.452864 0.983921 -1430 4 10.127 12.0766 30.6488 -15.6011 7.03664 -5.16285 -1431 6 40.1575 25.9297 9.14135 -21.3024 -7.39617 3.31146 -1432 4 40.7828 25.2448 9.36979 6.64832 -8.60816 0.262948 -1433 4 40.6901 26.6937 8.96671 10.3695 18.4246 -3.8085 -1434 6 43.1786 32.337 37.3292 -33.551 -18.2832 -9.28851 -1435 4 42.7165 32.8749 36.6701 14.8891 8.67062 4.46068 -1436 4 42.4294 31.7351 37.5575 24.0939 3.67107 5.33039 -1437 6 44.0961 6.28371 31.2632 9.51948 -8.69332 -33.5784 -1438 4 43.4914 6.92213 31.6058 -15.4833 19.2503 12.9198 -1439 4 44.559 5.89005 31.9835 8.76633 -8.79917 23.1113 -1440 6 10.2083 18.8859 19.6919 15.5822 -2.80816 -8.35433 -1441 4 10.2079 18.3466 20.4907 -1.18434 0.124911 0.125127 -1442 4 9.35433 19.315 19.665 -12.7717 3.54701 3.24565 -1443 6 7.05259 15.5816 15.0277 -11.6868 16.7681 -20.4125 -1444 4 7.21112 15.523 14.0697 -0.749561 -1.2692 3.08306 -1445 4 7.39122 14.7797 15.3874 7.84577 -24.8334 9.86289 -1446 6 24.5366 3.48359 27.8583 16.7503 5.69766 5.18976 -1447 4 23.7024 3.43271 28.3539 -4.73503 -2.50774 -10.2909 -1448 4 24.4259 3.10654 26.9763 -12.6917 -5.22111 2.5626 -1449 6 54.3931 31.8073 9.72289 -3.19054 17.1237 19.0803 -1450 4 53.9641 31.62 8.89214 -6.37727 -2.00813 -13.4715 -1451 4 54.1243 32.7301 9.92854 3.65429 -15.124 -2.64791 -1452 6 6.79493 17.0949 36.2025 -8.81624 7.47492 14.5397 -1453 4 5.9165 16.6466 36.2092 18.1356 5.91394 -12.2869 -1454 4 7.21103 17.1598 35.3293 -13.3551 -7.88765 -1.67162 -1455 6 28.633 7.46221 20.4165 -21.0133 14.9556 -29.8407 -1456 4 27.7506 7.6389 20.7846 4.83271 -6.12746 3.71795 -1457 4 28.5316 7.77661 19.4783 9.56717 -7.40103 22.9991 -1458 6 17.0376 1.7027 8.35788 5.34968 28.5352 32.0038 -1459 4 17.0661 0.753124 8.28199 -2.4228 -14.8367 -20.8379 -1460 4 16.762 2.22772 7.59129 -1.56258 -15.3605 -8.12812 -1461 6 19.1384 19.3343 35.5751 19.5023 3.30605 7.15282 -1462 4 18.4451 18.7061 35.4179 -10.2251 -8.92118 -4.92207 -1463 4 19.8852 18.808 35.914 -3.54436 4.66685 -0.605832 -1464 6 7.31639 31.3666 13.5695 -43.9944 -20.214 -21.2721 -1465 4 6.78612 30.574 13.8569 21.4883 17.7075 -0.698983 -1466 4 6.68503 31.7843 12.9295 22.0056 -0.349161 9.64417 -1467 6 16.674 5.24419 12.8556 -11.0373 -33.5815 5.02698 -1468 4 17.465 5.75961 12.9546 20.2971 3.5869 6.63236 -1469 4 16.7677 4.34295 13.2785 1.53127 21.9447 -10.2143 -1470 6 43.8803 12.7494 34.5747 -22.4085 -20.9808 -0.0671255 -1471 4 43.9515 13.6536 34.2548 -4.30422 8.76569 -3.51904 -1472 4 42.9542 12.429 34.42 18.6754 8.57765 -0.433924 -1473 6 42.6607 36.4569 28.5239 -16.8168 -12.4187 2.20896 -1474 4 42.172 37.2929 28.6321 13.9601 -3.78206 -4.91178 -1475 4 43.5913 36.5775 28.2923 4.62592 13.2896 -0.105187 -1476 6 35.3772 15.0586 6.04009 27.912 48.9275 -7.18458 -1477 4 35.887 15.8982 5.7897 -19.1126 -32.2788 12.1212 -1478 4 34.8045 14.9281 5.27735 -5.52923 -7.04807 -1.55591 -1479 6 19.4078 5.85855 6.1829 -40.2001 -18.9085 -3.31614 -1480 4 18.5441 5.99364 6.63156 8.43156 -9.10613 -8.3884 -1481 4 19.928 6.53616 6.54489 31.8426 31.4232 15.0663 -1482 6 29.261 38.1682 6.98131 -37.2303 32.1811 -6.57247 -1483 4 28.4837 38.0966 7.57517 15.5489 -1.40449 -6.41795 -1484 4 29.8842 37.5088 7.21603 19.671 -25.1607 10.5683 -1485 6 19.357 26.1782 8.47801 4.74765 -18.9961 17.9486 -1486 4 19.3733 25.7814 9.38274 -2.97831 10.6699 -17.265 -1487 4 20.1618 25.7953 8.09114 -4.76457 3.34604 0.730176 -1488 6 4.92328 16.6713 6.1398 7.47336 5.27851 2.26954 -1489 4 5.50113 17.3858 5.8203 -2.76896 -2.40075 1.51866 -1490 4 5.42288 15.8417 6.02573 -4.96937 12.5626 -0.560722 -1491 6 6.06184 16.6875 28.0703 25.9558 6.64688 1.10321 -1492 4 5.15824 16.4097 27.9597 -16.212 -5.66481 -14.185 -1493 4 6.48748 16.8231 27.1848 -21.9791 -6.00697 19.2504 -1494 6 21.7362 29.3702 22.1089 -17.2737 20.913 34.8846 -1495 4 21.4452 30.3289 22.1112 6.19611 -27.0689 0.469942 -1496 4 21.3293 28.9728 22.9428 14.5469 12.9694 -26.9427 -1497 6 24.4985 0.540505 12.8515 12.2489 -9.36427 2.95715 -1498 4 24.0437 0.939092 12.114 -3.50986 5.42614 -10.4761 -1499 4 24.1106 0.99496 13.5957 -0.561841 3.41965 12.163 -1500 6 18.4019 28.2584 40.3145 -11.401 19.5033 -15.6681 -1501 4 18.3886 27.6361 41.0165 -1.05122 -20.6036 22.2694 -1502 4 19.1831 28.024 39.826 8.23901 2.08545 -8.43276 -1503 6 10.3826 17.4565 21.9113 1.92941 -13.2413 3.45357 -1504 4 9.8824 16.6205 21.8349 3.82121 7.52813 2.02092 -1505 4 9.93899 17.9725 22.5913 -5.82795 2.16988 4.16556 -1506 6 13.5489 13.3588 39.6353 11.9209 29.8927 39.0415 -1507 4 13.8427 14.2544 39.3649 -8.64321 -16.3346 -3.85104 -1508 4 13.5548 13.4385 40.6332 -1.97454 -11.1079 -31.9482 -1509 6 19.5449 26.0093 24.7389 -52.2633 13.2593 -7.73686 -1510 4 19.57 25.3975 24.0097 10.2262 -10.7296 -10.4349 -1511 4 20.3304 26.0184 25.2393 35.6126 -10.3894 17.1361 -1512 6 8.93096 25.8929 20.0882 -7.71251 -64.4566 3.30388 -1513 4 8.30787 26.3938 20.5887 -11.4685 32.8171 11.63 -1514 4 9.62246 26.3511 19.648 20.7791 34.2926 -13.3665 -1515 6 13.4555 41.2072 30.5108 -10.8988 -15.928 5.69795 -1516 4 14.2767 41.1294 31.0436 -12.4449 -5.39064 -3.38157 -1517 4 12.7718 40.5451 30.8276 25.6688 18.9533 -5.69319 -1518 6 21.165 21.6707 11.1126 6.53241 11.8742 3.94385 -1519 4 20.8889 20.8699 10.6872 -6.5221 -17.8932 -11.6656 -1520 4 21.171 21.4318 12.0451 -0.673303 -0.892159 6.0991 -1521 6 43.5659 10.3222 15.565 -2.18625 -17.2881 -4.53442 -1522 4 43.269 9.50121 15.139 10.696 3.36153 7.59808 -1523 4 42.8911 10.937 15.2983 -10.0921 17.3133 -0.93945 -1524 6 23.5255 5.06673 12.3063 -8.27451 55.1521 -7.02327 -1525 4 23.4703 4.15364 12.096 -5.93718 -33.8878 -14.7403 -1526 4 23.077 5.57318 11.5535 15.1023 -26.9196 22.8331 -1527 6 9.29314 15.4001 4.25145 -3.86255 -4.02248 -25.5662 -1528 4 8.9509 16.1187 4.78154 1.1615 8.22379 13.6068 -1529 4 9.97933 14.9549 4.74249 8.84801 0.0887981 11.7331 -1530 6 26.7067 10.8779 17.5788 3.55047 -19.7627 -22.9275 -1531 4 26.5537 10.995 18.4988 -3.13636 8.79354 30.8805 -1532 4 26.79 11.729 17.1566 -1.16375 6.51516 1.16674 -1533 6 26.0497 23.6027 33.6801 19.5894 25.2732 20.1931 -1534 4 25.4452 23.9936 33.0304 1.52608 5.68176 -1.06817 -1535 4 26.6384 24.3139 34.1277 -30.0139 -24.8801 -23.6693 -1536 6 7.5709 10.5028 28.9083 -0.962228 -19.583 -21.6711 -1537 4 6.74329 10.4799 29.4005 3.80738 8.46019 8.36633 -1538 4 8.19878 11.0832 29.3397 0.629116 8.24646 12.7121 -1539 6 16.498 16.9072 24.6485 7.82025 23.6222 16.3151 -1540 4 16.0345 17.7596 24.5588 5.31695 -3.73313 -0.390286 -1541 4 16.1792 16.4208 23.9083 -7.11448 -16.9587 -21.9433 -1542 6 12.549 12.7866 0.448591 8.35618 6.39845 34.9671 -1543 4 12.9768 12.9146 1.38779 -15.5602 -17.6496 -50.0052 -1544 4 12.7689 11.9205 0.0349689 0.659473 7.36742 13.3893 -1545 6 6.80731 2.45617 9.05869 -7.23501 -7.03372 -0.578084 -1546 4 7.10343 3.02287 9.78944 7.77528 -6.31722 -2.26682 -1547 4 7.3272 1.63733 8.99034 2.01029 5.74015 6.94656 -1548 6 28.8877 11.8706 12.0154 41.6386 34.6329 -2.99516 -1549 4 28.2108 12.4771 11.6895 -6.34049 1.49886 1.56166 -1550 4 29.7533 12.3393 11.8008 -29.7579 -18.4108 8.17464 -1551 6 44.6745 32.5962 29.7139 -34.2161 4.66467 6.73964 -1552 4 43.7628 32.9784 29.4642 35.9402 -16.1761 10.2258 -1553 4 44.5125 31.9002 30.3967 -1.3182 18.2082 -15.8911 -1554 6 28.5995 15.1068 32.2872 13.2766 -51.3111 -20.1848 -1555 4 29.0279 15.8582 31.8991 2.31019 19.0875 -3.40369 -1556 4 29.0943 14.3419 31.8537 -21.7517 23.8731 20.1718 -1557 6 1.14062 22.1898 33.6289 -39.3586 14.574 19.5436 -1558 4 0.65227 22.798 33.0535 3.91391 -2.7929 6.08546 -1559 4 1.82717 21.8879 33.088 34.4042 -16.5957 -27.8984 -1560 6 17.4513 16.8201 9.93098 -1.82085 -23.3459 26.2514 -1561 4 17.8906 17.1746 9.18159 7.86355 15.3521 -22.135 -1562 4 18.0267 16.0779 10.2085 -7.73246 7.19916 -1.96586 -1563 6 18.7435 29.8048 14.4095 21.7061 -3.72347 40.0221 -1564 4 19.5652 29.5706 14.9087 -19.4331 3.67999 -8.42588 -1565 4 18.9661 29.6909 13.4944 1.97037 -1.23698 -19.2163 -1566 6 39.4071 6.51101 13.0179 12.0574 6.81682 -11.0022 -1567 4 39.7785 7.30288 12.5709 -10.193 -11.7897 7.6563 -1568 4 39.9532 5.78104 12.6849 -4.03584 4.98089 5.48617 -1569 6 54.0977 38.2821 14.3159 8.76467 -13.509 23.2458 -1570 4 53.5116 38.6447 15.0061 0.0542658 1.01747 -18.4972 -1571 4 53.8554 38.6311 13.4594 -12.9742 11.219 -5.93773 -1572 6 7.52036 32.013 20.9427 34.362 14.2167 21.5407 -1573 4 7.05735 31.9924 20.1252 -18.8869 -6.37038 -21.2822 -1574 4 7.04171 31.4816 21.5607 -16.1882 -11.3569 11.099 -1575 6 26.965 15.5039 13.8257 -10.8147 -22.3452 14.7237 -1576 4 27.2177 14.7358 14.3683 8.65177 6.42067 -5.59001 -1577 4 26.0429 15.6169 14.0906 -6.80859 9.66341 -6.51148 -1578 6 18.3782 16.4473 32.1249 -4.95226 -1.86998 -9.87987 -1579 4 18.1426 16.6374 31.1969 4.73263 -0.719504 8.39792 -1580 4 19.0836 17.0573 32.3614 6.73072 6.57595 -2.73442 -1581 6 52.4873 31.678 23.2415 -44.1119 -6.58328 47.4356 -1582 4 52.4708 32.2686 24.0415 7.23299 -8.75358 -21.8316 -1583 4 53.1739 31.883 22.645 31.3465 14.6123 -23.9869 -1584 6 2.16824 9.71317 28.2162 5.46837 -18.1801 7.45826 -1585 4 2.48183 10.5213 27.7929 -7.61484 8.72751 3.65687 -1586 4 1.37959 9.87032 28.768 3.44281 10.2362 -4.06622 -1587 6 32.9194 0.0905733 22.5781 10.5432 -20.5017 -7.42813 -1588 4 33.2395 41.1185 22.3208 -17.3926 6.61176 1.08087 -1589 4 33.7441 0.505918 22.8191 5.29332 16.1982 3.6992 -1590 6 20.7309 41.5697 38.6372 28.3147 -14.9122 -44.687 -1591 4 20.0328 41.0591 39.0281 -13.7779 -1.58578 11.2509 -1592 4 21.0348 40.9602 37.8857 -7.98591 29.4899 32.1121 -1593 6 43.3035 24.332 12.1458 11.7575 -1.61212 -4.71191 -1594 4 43.2118 25.2792 12.3722 8.64503 -11.1136 -9.01316 -1595 4 44.1249 24.1975 11.6011 -17.6772 13.9566 14.4164 -1596 6 22.028 36.2965 11.8178 -12.5217 11.0116 -6.64335 -1597 4 21.6755 36.9888 11.229 7.35556 -7.61462 10.605 -1598 4 22.8593 36.0261 11.4203 4.02803 -2.23458 -0.408194 -1599 6 50.7458 20.5312 30.3336 -27.3371 19.0798 0.575242 -1600 4 50.2829 20.0188 31.024 4.3389 0.549123 -5.17754 -1601 4 50.1148 21.2814 30.1453 20.3707 -20.1638 4.65154 -1602 6 20.8352 3.85006 18.1924 -4.58005 6.82859 16.651 -1603 4 21.6331 4.17131 17.7775 4.55578 1.29171 -4.07778 -1604 4 20.7516 4.34878 19.0287 -0.852135 -6.30171 -7.97465 -1605 6 4.00732 20.6422 6.98905 -51.5603 -31.2986 19.6291 -1606 4 3.1116 20.4695 6.56725 35.2765 12.481 -1.34365 -1607 4 3.83148 20.2497 7.8921 17.5771 16.9916 -21.2359 -1608 6 11.9503 15.4361 41.4392 2.8915 -19.3712 8.63656 -1609 4 11.9967 14.4718 41.7234 3.98465 29.7679 -14.4511 -1610 4 12.4631 15.5787 40.6176 -3.08486 -9.43894 7.49139 -1611 6 3.00006 18.5443 38.9307 7.29951 -23.84 25.6029 -1612 4 3.57591 17.7463 38.8471 -9.50595 12.5214 2.28144 -1613 4 2.93408 18.9335 38.0756 -3.85177 13.2219 -26.1975 -1614 6 8.60604 38.8696 11.3027 41.4164 30.2615 0.48057 -1615 4 9.41419 39.0226 10.7506 -16.8144 -5.25469 8.62565 -1616 4 8.21901 38.0768 10.9944 -17.9318 -38.1368 -15.4555 -1617 6 12.9777 33.9736 38.4849 13.2116 9.7409 3.49313 -1618 4 12.6169 33.1824 38.0476 12.8065 1.18326 0.516457 -1619 4 13.9558 34.0654 38.367 -20.6967 -9.66923 -0.235313 -1620 6 4.68265 11.9882 6.05233 -5.36104 -17.6375 -21.4001 -1621 4 3.82121 11.6194 5.80881 -7.3972 4.97776 10.103 -1622 4 5.22981 11.6659 5.30604 -0.806592 6.4598 12.5779 -1623 6 10.8388 15.9226 25.2234 -25.8257 0.885817 -3.68505 -1624 4 11.7194 16.2357 25.361 23.5714 9.8582 3.12124 -1625 4 10.3656 16.637 24.773 5.49819 -5.38784 0.449897 -1626 6 20.7519 3.25216 6.54608 14.2232 16.6176 4.63006 -1627 4 20.286 2.47445 6.25961 -10.3965 -11.4853 -2.16446 -1628 4 20.1859 4.03183 6.47283 -6.25253 -2.40724 -3.99784 -1629 6 47.6296 39.155 31.2075 -6.94169 16.2372 -29.2685 -1630 4 46.6717 39.1522 30.9686 19.778 5.05469 4.61154 -1631 4 48.0746 39.7923 30.5789 -18.3255 -25.0069 20.1215 -1632 6 8.32942 27.7692 27.6861 -22.9675 10.5768 13.2964 -1633 4 7.92083 27.0814 28.2574 8.55111 11.2092 -8.24047 -1634 4 9.05389 27.3382 27.2479 10.5137 -11.4359 -5.41666 -1635 6 33.26 40.3166 33.4176 17.9089 -0.14465 -4.13778 -1636 4 32.5337 40.9457 33.2593 10.2249 -4.59604 -5.86803 -1637 4 34.0027 40.4737 32.781 -17.2015 3.54767 8.86095 -1638 6 24.5063 34.6298 27.2698 0.491312 8.45089 -9.78892 -1639 4 24.8706 35.531 27.0561 -9.74802 -22.5685 0.190878 -1640 4 24.1 34.2837 26.4337 10.8101 11.1551 19.1745 -1641 6 13.3248 36.7606 35.7302 31.7841 1.54421 8.12469 -1642 4 14.2215 36.6075 36.119 -13.0291 10.9369 -8.07597 -1643 4 12.8242 36.0333 36.0767 -19.6956 -11.898 1.78685 -1644 6 34.0654 20.1519 33.2169 18.328 45.6356 -7.38724 -1645 4 34.7846 20.5927 32.7056 -13.2567 -20.8909 7.62801 -1646 4 33.6055 20.9496 33.5712 -4.62613 -21.3045 2.82084 -1647 6 22.8301 33.56 31.6141 4.86266 11.3389 -12.2002 -1648 4 23.5774 34.1707 31.5466 -2.83601 4.36281 -5.03091 -1649 4 23.1188 32.9172 32.2538 0.234413 -13.6868 11.6365 -1650 6 23.7437 2.42751 19.8437 5.37542 22.288 12.015 -1651 4 24.549 1.92657 19.7151 11.8542 -9.34304 -3.08207 -1652 4 23.0522 1.96699 19.3939 -17.1839 -15.7883 -12.7178 -1653 6 10.5922 1.64055 20.5239 -11.6119 -4.18685 -4.47424 -1654 4 10.0475 0.976152 20.0603 6.63037 0.339841 6.84259 -1655 4 10.5 2.45781 20.009 1.22375 1.55874 1.33627 -1656 6 6.49834 24.8637 7.80908 13.1619 -16.462 -27.2261 -1657 4 7.39752 24.8711 7.42138 -7.39511 8.18905 12.026 -1658 4 6.07255 24.1767 7.26903 -7.5733 6.7583 6.8074 -1659 6 54.7892 32.5297 25.4757 -1.36407 18.5665 -18.8778 -1660 4 54.0312 33.1434 25.3693 10.0694 -13.7478 6.1371 -1661 4 0.333918 32.6202 24.6425 -12.8409 -6.42816 22.883 -1662 6 6.2467 20.1884 28.9797 -14.5872 3.94595 -2.55046 -1663 4 5.42154 20.1642 28.4577 8.07739 1.90281 8.6477 -1664 4 6.84484 19.6236 28.4838 10.3646 -4.74821 0.341067 -1665 6 50.0565 21.6117 11.3373 -2.04109 28.5423 -29.4123 -1666 4 50.95 21.7264 10.9878 2.40449 3.31798 -5.14809 -1667 4 50.1463 20.9073 11.9368 0.900865 -33.3483 27.1981 -1668 6 43.4794 33.5181 19.6392 10.2306 -3.22473 -8.26676 -1669 4 43.7308 33.5714 20.5426 20.9097 -0.172793 18.6354 -1670 4 42.5556 33.6283 19.7345 -31.1875 3.87355 -8.92325 -1671 6 30.8203 7.18413 41.0653 -47.5647 29.7584 13.5959 -1672 4 29.9879 7.63165 40.681 33.629 -21.8567 10.9994 -1673 4 30.7637 7.50249 0.10761 7.36747 -14.0232 -31.1296 -1674 6 12.1328 25.8622 11.0863 -33.3162 -17.1307 -4.35232 -1675 4 11.2035 26.0164 10.7385 31.652 5.74526 10.6132 -1676 4 12.7063 26.6022 10.9281 7.22016 21.1466 -6.88425 -1677 6 47.8272 5.81934 17.7377 34.4122 -10.5063 -19.6374 -1678 4 48.0885 5.28838 16.9377 -7.84164 17.03 17.5567 -1679 4 48.6906 6.1712 18.0872 -20.5621 -5.0871 -4.09565 -1680 6 35.1646 12.9005 16.5891 -8.94037 2.15609 -8.82704 -1681 4 35.428 13.0005 17.5199 -6.39768 8.78744 -5.13392 -1682 4 34.5308 13.6301 16.3523 17.2323 -15.7422 12.9621 -1683 6 10.4611 10.6156 33.9687 -31.8989 -9.58391 14.7288 -1684 4 10.7981 11.3375 34.5166 5.24051 -2.75865 -7.26377 -1685 4 9.62118 10.4004 34.4306 17.5569 -1.50819 -12.473 -1686 6 9.86916 7.4616 9.67483 -1.17411 0.415312 -19.5192 -1687 4 9.17172 8.12646 9.7346 0.921409 2.8109 10.1471 -1688 4 9.97058 7.3459 8.70248 1.1017 -0.154201 19.4763 -1689 6 11.1489 9.5612 29.1408 -3.50418 -13.4139 2.93109 -1690 4 10.6848 9.26325 29.9428 4.68224 5.10434 -5.79998 -1691 4 11.3989 8.73954 28.6776 0.998479 5.88331 1.3781 -1692 6 46.4028 12.7539 37.8993 8.34964 0.221 -8.93676 -1693 4 46.6625 12.9969 36.9769 -3.46511 -1.57209 17.4302 -1694 4 46.8246 13.3669 38.5286 -1.63466 -3.53539 -5.22058 -1695 6 4.76485 19.028 16.0085 -13.5875 12.8334 -9.71245 -1696 4 4.2246 19.0797 16.8211 14.4547 -7.44532 -2.23877 -1697 4 5.5965 18.5831 16.2078 1.83868 -2.3176 10.3072 -1698 6 50.2593 39.8135 19.3633 -11.209 7.32279 -16.1387 -1699 4 50.2357 39.0929 20.0186 -9.83071 -0.813057 -10.1916 -1700 4 49.5811 39.7404 18.6324 20.3589 -6.83946 23.6454 -1701 6 3.57863 23.2976 26.309 -19.8478 3.89203 -2.42552 -1702 4 2.95325 23.1663 25.5593 11.1236 -1.69658 12.5574 -1703 4 3.09228 23.9147 26.9028 8.7219 -10.8877 -9.85517 -1704 6 43.325 18.2347 20.509 -6.81505 -1.42332 -3.46621 -1705 4 42.8171 19.0284 20.7204 1.20306 1.51529 1.23812 -1706 4 43.8577 18.0426 21.2915 2.12676 -2.58083 4.4502 -1707 6 14.5031 41.5275 19.7277 -3.40329 -5.13047 -40.8094 -1708 4 13.9246 41.7804 20.437 0.184992 5.83632 25.1113 -1709 4 15.42 41.4218 19.9774 10.3149 -1.62678 14.571 -1710 6 29.2836 29.8681 26.9083 14.7251 3.00272 -32.0725 -1711 4 29.2754 29.741 25.8744 6.18055 14.2787 56.2455 -1712 4 30.1283 30.2623 27.2985 -22.384 -15.5718 -22.4063 -1713 6 6.3217 26.153 11.5726 -10.9318 2.11689 -6.65038 -1714 4 6.21736 25.7454 12.4421 7.16784 6.77942 9.71283 -1715 4 6.96084 26.8819 11.5675 -0.124344 -5.20772 8.78036 -1716 6 27.6636 9.22988 15.2432 27.2347 15.0341 -6.49447 -1717 4 28.4103 9.83484 14.9873 -20.1055 -14.3916 8.85848 -1718 4 27.7674 8.48088 14.6445 -1.45999 -3.40178 1.02673 -1719 6 29.7804 38.0662 17.0819 -1.94795 -3.59677 -9.66723 -1720 4 29.6031 37.2203 16.6025 -2.55573 18.1678 4.54076 -1721 4 29.1155 38.7497 16.8561 3.55432 -16.3657 1.57327 -1722 6 52.2257 28.7184 4.26028 43.5541 11.735 -13.9492 -1723 4 53.1498 28.7813 3.86382 -28.9168 1.3453 15.0129 -1724 4 51.9642 27.8111 4.13511 -4.98861 -18.1961 -3.0857 -1725 6 17.1716 16.6708 6.09349 0.800403 22.8617 11.3476 -1726 4 16.9906 17.4665 6.64994 5.32834 -8.85643 -15.9231 -1727 4 16.9912 15.9587 6.69883 -0.0606397 -19.1034 5.18453 -1728 6 36.6551 7.54529 33.4256 0.520164 -21.8515 26.6937 -1729 4 35.9994 7.02185 33.9501 8.71508 10.7979 -12.9224 -1730 4 36.139 7.85703 32.6949 -12.9525 8.58568 -17.7829 -1731 6 26.1712 3.13186 9.59195 18.1066 21.2961 -28.5304 -1732 4 26.5502 3.5196 10.357 16.0028 12.4994 23.003 -1733 4 25.6506 2.45477 9.93435 -32.3265 -38.1289 14.2303 -1734 6 1.19956 17.1196 33.1708 -2.2935 18.3305 -9.07621 -1735 4 1.01553 17.8006 32.4822 1.56489 -10.8534 12.1427 -1736 4 0.844206 17.4429 34.0214 2.04572 -1.59411 -6.06332 -1737 6 29.1739 10.178 5.37516 -2.40587 -18.3881 11.7134 -1738 4 28.5386 10.354 6.08377 0.376669 4.93981 -3.98875 -1739 4 29.4881 9.26834 5.54278 -5.29161 7.67482 -7.40705 -1740 6 9.22817 21.1342 0.188585 30.2393 3.90367 9.01386 -1741 4 10.0008 20.6689 41.6954 -19.6386 2.89796 1.05729 -1742 4 8.40981 20.8027 41.7407 -2.68979 -7.66638 -7.21336 -1743 6 7.42006 26.8879 34.8536 3.14545 16.5486 30.4349 -1744 4 7.04622 27.0927 35.7464 10.1233 -6.04195 -26.4158 -1745 4 6.87255 26.19 34.5186 -13.4343 -18.5802 -10.0193 -1746 6 18.6153 10.1647 3.02259 -21.2705 37.3854 6.86975 -1747 4 17.9982 9.42011 2.89287 2.11135 15.8633 3.52195 -1748 4 18.115 11.0437 3.25865 19.508 -44.5053 -11.6159 -1749 6 13.1266 21.2208 25.207 -7.78894 4.80204 -7.88194 -1750 4 12.927 21.6586 24.3646 3.95449 -7.72121 4.87382 -1751 4 12.8054 20.3208 25.1571 -2.69895 -8.80511 -3.48609 -1752 6 4.90585 24.4116 40.531 -24.4864 -14.2944 -35.1794 -1753 4 5.64285 24.6041 41.0938 21.6142 3.21823 7.1591 -1754 4 5.22115 23.997 39.6806 -3.1008 12.4445 27.1665 -1755 6 54.7234 6.29054 9.93868 16.9838 3.76988 -11.4262 -1756 4 54.1595 6.0167 10.6465 -16.0707 -8.53288 16.3243 -1757 4 -0.00708757 7.17696 10.1972 2.88265 8.42125 0.296955 -1758 6 51.7481 16.6603 19.3703 -0.380283 5.87397 -29.4424 -1759 4 51.6376 16.2748 18.4816 -6.94363 -1.60509 11.109 -1760 4 52.3909 17.3585 19.2003 6.35466 6.30558 5.78841 -1761 6 38.6244 2.9738 13.1093 11.8256 2.30897 44.7329 -1762 4 38.5518 3.44318 13.9917 -0.399232 -9.9856 -23.4333 -1763 4 38.2423 3.54447 12.4592 -11.1085 17.5319 -17.0773 -1764 6 19.4422 35.7095 9.59568 3.40577 -0.828385 -4.73593 -1765 4 18.7414 36.105 9.07989 -9.16576 -3.00828 -7.06541 -1766 4 19.0009 35.4265 10.4088 3.97598 4.46758 -4.25365 -1767 6 46.943 37.6271 25.6985 10.3793 1.77648 -5.56802 -1768 4 47.12 37.9785 24.823 -9.34628 8.6078 -10.4475 -1769 4 47.7536 37.1497 25.8683 2.27046 -5.59472 9.98269 -1770 6 20.0359 17.269 14.7493 3.99527 -1.04076 21.685 -1771 4 19.226 17.5112 15.2169 -1.54973 1.23777 -13.9596 -1772 4 20.6203 17.0021 15.471 1.89523 -0.789097 -10.2839 -1773 6 24.7462 29.2867 3.75843 -10.1451 -8.18783 10.4774 -1774 4 24.6712 28.3277 3.51733 13.2212 23.8029 -9.5704 -1775 4 25.3186 29.8222 3.19111 0.258423 -15.3949 -10.1904 -1776 6 3.43 8.91865 6.82525 30.9316 4.78471 42.1024 -1777 4 3.12906 8.84201 7.76799 3.51474 0.65101 -30.0512 -1778 4 4.4001 9.15772 6.93718 -35.8795 -6.21414 -10.2854 -1779 6 17.4867 30.5875 19.7089 25.363 -13.1809 -11.8275 -1780 4 18.4189 30.3609 19.3993 -33.7851 8.31766 10.936 -1781 4 16.9116 29.8624 19.4038 1.038 7.7974 -2.73085 -1782 6 13.2718 16.1862 39.0546 8.76191 -18.4723 6.03369 -1783 4 13.8233 16.8904 39.4031 3.30361 7.54485 1.72389 -1784 4 12.5422 16.5765 38.5789 -11.7633 13.4881 -8.40344 -1785 6 23.832 27.9756 11.5898 -7.03122 5.38421 -2.05105 -1786 4 23.0756 27.4469 11.9259 8.81977 12.3317 -3.01362 -1787 4 23.7182 28.9056 11.8688 -5.28793 -12.9553 -0.41204 -1788 6 14.4579 24.426 21.2343 -3.66896 12.863 -1.79834 -1789 4 13.9584 25.2806 21.2855 7.33453 -15.5065 2.73981 -1790 4 14.2661 23.9117 22.0367 -3.91682 9.90798 -0.991428 -1791 6 46.6073 15.1543 22.2965 -20.8333 -3.77381 -11.8272 -1792 4 45.9584 14.6421 21.811 -6.87655 -3.95362 10.1018 -1793 4 47.2458 15.2644 21.6001 24.1162 10.8017 0.759212 -1794 6 19.1409 29.7195 11.8497 24.0494 -34.2428 10.0272 -1795 4 18.8784 30.5975 11.5793 -19.1418 4.86007 -17.3781 -1796 4 18.6106 28.9994 11.4276 0.263541 23.8948 1.0376 -1797 6 36.9127 18.8084 27.6222 -22.9356 -21.6011 26.171 -1798 4 36.4352 18.471 26.8408 6.36827 4.7914 5.64024 -1799 4 36.536 18.2194 28.3533 14.6987 24.2872 -28.1415 -1800 6 35.8684 17.5378 25.4906 20.6945 -0.513689 -30.4481 -1801 4 36.5966 17.7728 24.866 -15.8574 8.27186 11.6809 -1802 4 35.9779 16.5759 25.48 -10.902 2.42848 10.2606 -1803 6 8.03691 41.9141 31.5248 13.0394 10.4535 -6.8036 -1804 4 8.57921 41.2412 31.9888 -13.1962 14.522 -11.1095 -1805 4 8.63283 0.684743 31.1326 -8.3799 -15.4286 7.32752 -1806 6 31.7059 34.8342 17.9371 1.99631 -25.0047 -8.79133 -1807 4 32.5911 34.4609 17.7211 -13.4776 12.334 6.09844 -1808 4 31.8527 35.7258 18.2497 13.1847 15.6537 3.27409 -1809 6 22.1093 41.055 5.1451 11.5479 29.9587 -53.8497 -1810 4 22.1004 40.5969 5.93279 -2.68624 -33.8843 55.363 -1811 4 22.7885 40.6204 4.60559 -4.38419 0.844423 3.37931 -1812 6 11.6153 5.16618 29.5584 -27.6475 13.1782 12.6346 -1813 4 12.1606 4.37097 29.6057 -8.91967 -2.9702 4.15115 -1814 4 10.7377 5.1092 30.0631 35.581 -10.2726 -16.0904 -1815 6 13.0239 9.45481 21.0754 -25.8377 -26.1508 -25.9824 -1816 4 13.6778 9.97234 21.4999 31.652 16.6928 15.5055 -1817 4 13.4195 8.72209 20.5617 -0.589626 12.3395 6.44381 -1818 6 12.4227 4.1736 0.163828 29.6522 45.8695 -12.8421 -1819 4 12.6651 3.77524 1.00427 0.341759 -1.42745 2.51987 -1820 4 13.0617 4.97102 0.020112 -31.9214 -41.0145 4.8633 -1821 6 45.168 14.6284 28.1023 4.783 -10.4532 13.0266 -1822 4 45.253 14.8969 27.1759 8.39119 -6.85383 -0.732919 -1823 4 45.9575 14.0916 28.3529 -13.3622 13.2892 -14.7888 -1824 6 52.571 19.2551 0.894665 -6.12931 -19.318 2.27414 -1825 4 52.6102 19.199 41.8388 0.592413 0.00811024 1.08479 -1826 4 52.8129 20.1442 1.11528 6.55776 18.4237 2.43046 -1827 6 0.161625 18.5694 30.5785 -3.0227 0.535636 4.36465 -1828 4 0.968981 18.7291 30.0798 6.18464 -7.16445 -2.53371 -1829 4 54.7907 19.4514 30.677 -10.8229 5.89199 6.00525 -1830 6 17.6528 28.1849 1.96402 -7.28907 9.7522 11.2687 -1831 4 16.9769 28.8628 1.74785 9.23997 -9.27082 -2.31394 -1832 4 17.6006 28.1534 2.93661 3.56557 1.38454 -8.44201 -1833 6 22.5099 30.1653 5.01109 -1.02808 20.8676 -0.473944 -1834 4 23.1753 30.1014 4.30975 -2.49536 -9.56192 4.09657 -1835 4 22.058 29.3206 5.04766 -1.45363 -6.71999 -4.50103 -1836 6 11.4023 8.80853 17.6459 -26.9993 9.53928 -4.75555 -1837 4 11.8645 8.1762 18.2108 15.3222 4.18532 1.52515 -1838 4 11.9865 9.48216 17.2519 4.47877 -12.4161 10.2871 -1839 6 32.2917 3.59674 26.8117 35.3382 32.7507 -4.14644 -1840 4 31.8458 3.34967 26.0065 -10.4154 -4.5889 -14.8452 -1841 4 32.8806 4.37505 26.5671 -21.1848 -26.3524 0.379863 -1842 6 26.835 37.1568 15.6529 -0.874066 14.8773 29.2405 -1843 4 26.7488 37.4766 16.567 0.376185 8.65421 -15.6923 -1844 4 26.6891 36.2303 15.7909 -0.851881 -23.4278 -14.9094 -1845 6 22.9473 3.40289 22.286 14.7574 -3.5158 -4.23343 -1846 4 23.2792 2.98888 21.4515 -4.53852 7.92848 16.4552 -1847 4 23.7307 3.68139 22.8048 -11.9145 -5.32443 -10.4265 -1848 6 14.6269 28.2214 5.19572 6.06687 6.51489 2.87291 -1849 4 14.1454 28.1555 4.36712 -3.39073 -3.27129 -8.45242 -1850 4 14.2747 28.9991 5.64824 0.61258 -1.12864 1.62503 -1851 6 20.2538 37.2031 16.5466 -28.2562 5.81675 18.2866 -1852 4 21.1004 37.4666 16.2032 21.0823 8.59207 -3.85991 -1853 4 20.0754 37.7549 17.3418 4.82626 -5.93036 -10.2325 -1854 6 17.9544 28.5616 23.889 16.4449 -8.57642 -4.83649 -1855 4 18.808 28.1928 23.5683 -20.3084 2.86715 8.85187 -1856 4 17.2559 27.9215 23.6535 6.51898 5.694 -2.26134 -1857 6 33.646 24.2349 25.2286 -4.54069 1.10679 -14.8717 -1858 4 33.6591 23.269 25.0602 3.54988 10.512 10.2941 -1859 4 34.0237 24.3938 26.1034 0.864522 -9.38336 -2.59148 -1860 6 9.98122 17.6138 2.21344 7.43797 -27.5786 -7.49496 -1861 4 10.832 17.5317 1.73219 -10.6429 3.93943 7.97636 -1862 4 9.86311 16.7639 2.69719 0.409905 15.8492 -4.6087 -1863 6 24.3357 36.801 8.92185 2.98992 -6.60779 12.1866 -1864 4 24.0742 37.6409 8.56425 -5.30422 15.3919 -5.44039 -1865 4 24.7315 37 9.77917 -2.43549 -6.6012 -3.30269 -1866 6 14.4004 4.29557 27.7519 47.583 -3.32523 5.14754 -1867 4 15.335 4.40276 27.3948 -30.4143 -4.44284 13.8265 -1868 4 13.81 4.42145 27.0177 -13.2435 3.17509 -11.8406 -1869 6 13.214 25.4576 35.3169 -22.1271 -24.6319 4.29258 -1870 4 13.1587 25.1592 36.2444 11.1778 9.47444 -6.90086 -1871 4 12.4637 24.9943 34.8985 11.1514 12.2923 -1.08233 -1872 6 43.7301 33.1781 24.4042 -1.93578 -20.5981 16.0744 -1873 4 44.3223 32.959 25.1725 -10.0543 8.3706 -19.7015 -1874 4 44.0713 33.9344 23.9169 6.22405 5.02536 3.22562 -1875 6 6.9686 30.4099 7.14637 29.0056 7.39031 21.9321 -1876 4 6.75777 29.9621 7.98042 -5.17066 0.417247 -5.37485 -1877 4 6.23168 30.2842 6.57126 -23.4728 -6.8193 -11.7975 -1878 6 44.4308 39.4237 21.7855 -4.33275 0.914597 7.54549 -1879 4 43.8654 38.932 21.1541 10.179 9.64354 2.62582 -1880 4 45.001 40.0603 21.3196 -6.51882 -12.4268 -7.79327 -1881 6 1.18424 16.4398 24.9903 -32.4903 25.5998 2.59769 -1882 4 0.976951 16.9992 24.2076 17.4753 -17.2203 8.72915 -1883 4 0.385168 16.6115 25.5394 23.4019 -14.126 -4.16352 -1884 6 8.17355 33.8284 10.6836 -2.7688 -6.92624 14.1509 -1885 4 8.34263 33.4451 9.83813 20.7133 -1.8248 -25.0865 -1886 4 7.32622 33.4212 10.8229 -22.0824 -0.650197 20.9959 -1887 6 45.3734 15.866 40.492 8.57481 -12.1553 -4.93844 -1888 4 44.519 15.6937 40.0698 -0.240559 4.546 7.41406 -1889 4 45.2892 16.6061 41.0987 -5.95018 0.957053 0.609678 -1890 6 38.79 4.28815 15.8976 0.37918 -2.10791 -10.8791 -1891 4 39.6838 3.98516 16.099 -1.14178 2.00828 6.51653 -1892 4 38.4576 4.71748 16.7012 5.69678 -4.45181 -3.36891 -1893 6 21.0946 9.20757 23.9781 -15.5567 7.8487 -28.256 -1894 4 20.9171 8.74785 23.1381 12.0597 -4.77706 12.6228 -1895 4 20.522 9.98378 23.8483 8.03519 -2.74416 16.612 -1896 6 6.47513 36.1489 20.0112 1.62078 -0.443995 1.26518 -1897 4 5.91587 35.3892 19.7749 1.1588 6.62155 -0.72477 -1898 4 7.29927 35.7814 20.3561 -3.99682 -1.77997 -1.59627 -1899 6 17.7466 23.4563 11.2529 28.5847 -29.2717 26.027 -1900 4 17.0283 23.9723 10.9251 -27.3158 17.875 -1.49359 -1901 4 17.6201 23.2782 12.2162 -8.22502 9.28058 -23.7318 -1902 6 2.23619 39.2644 23.5388 49.8561 -28.1857 -22.6679 -1903 4 2.97831 38.9599 24.1359 -27.9038 8.524 -11.8523 -1904 4 2.61824 39.0932 22.6246 -22.7997 11.7085 33.9524 -1905 6 21.7216 10.3211 3.08421 -18.2449 14.4951 30.0936 -1906 4 21.8041 10.0076 2.215 15.0715 -18.3252 -42.7176 -1907 4 20.7597 10.3501 3.18369 2.1836 1.89441 6.77029 -1908 6 13.3346 37.6456 26.8309 31.2085 -13.7023 -2.95714 -1909 4 12.8405 36.9633 27.2803 -9.16641 -7.21061 8.74396 -1910 4 14.167 37.1703 26.5501 -23.1686 18.0804 4.61389 -1911 6 45.6739 9.85296 8.82966 10.4005 6.57186 1.33947 -1912 4 45.3411 9.70411 7.93855 -5.0879 -2.60549 -0.62074 -1913 4 45.1871 9.30295 9.44221 -8.90854 -6.98805 -1.17873 -1914 6 39.813 32.3454 29.581 6.89703 -12.1014 5.95535 -1915 4 39.6485 31.4219 29.3549 -7.08038 -1.01192 -10.7476 -1916 4 40.3223 32.2375 30.3827 0.600223 8.34958 5.32896 -1917 6 39.1399 32.1558 8.97291 22.8595 -6.45003 -40.3239 -1918 4 39.6086 32.0592 8.09926 -10.5081 2.64219 35.3633 -1919 4 38.2198 32.2158 8.71089 -7.955 1.72328 8.07951 -1920 6 29.7568 11.3071 40.3305 36.1908 -28.2332 -10.1569 -1921 4 29.0987 10.6276 40.5022 -6.8613 -0.261357 1.73371 -1922 4 30.5966 10.7518 40.2867 -25.0211 23.0598 -1.19829 -1923 6 24.8367 19.8778 29.8512 -3.76004 22.8831 22.3698 -1924 4 24.8428 19.0032 30.2276 -1.20959 -17.1847 2.11456 -1925 4 24.5914 20.4528 30.618 6.24059 -13.3215 -18.0816 -1926 6 50.0702 29.4819 2.87168 7.70946 6.50978 -10.1722 -1927 4 50.8345 29.4231 3.46787 -5.92296 0.441099 -8.02421 -1928 4 50.4135 29.3271 1.96617 -11.3825 0.248157 19.2026 -1929 6 26.3309 13.2577 37.9673 -13.8105 -3.9786 -34.6653 -1930 4 27.2227 13.0528 37.6163 -4.21147 3.58808 27.148 -1931 4 26.2568 13.475 38.8976 18.37 3.27206 13.6317 -1932 6 24.3356 13.8068 16.1475 3.59325 -0.347239 -0.208698 -1933 4 24.7367 14.1162 16.9522 4.68271 -6.41054 14.6744 -1934 4 24.1923 14.631 15.6832 -6.43367 3.48529 -13.6665 -1935 6 21.9593 25.0956 8.01078 27.9223 3.76027 7.52529 -1936 4 22.6404 25.6041 7.51239 -14.7718 -5.75747 5.32796 -1937 4 22.4795 24.6555 8.71494 -11.0917 7.59151 -10.9937 -1938 6 50.1732 25.2931 29.034 -22.8769 -27.0861 -14.4889 -1939 4 50.9231 25.1249 28.4453 9.52927 7.92169 5.9345 -1940 4 50.3853 25.9631 29.6741 16.3661 14.9722 8.20298 -1941 6 23.1854 6.82331 7.6223 5.22953 23.7057 -4.54178 -1942 4 23.9785 7.3899 7.84298 -26.8007 -12.7469 -6.01791 -1943 4 22.4118 7.42329 7.468 18.2581 -13.076 4.30509 -1944 6 6.92213 5.8571 20.8332 2.72627 6.95854 -11.5419 -1945 4 7.54915 6.58218 20.6217 -11.8273 -13.0803 1.39721 -1946 4 6.56012 5.53917 19.9848 5.57208 -2.46181 7.62025 -1947 6 25.395 39.7583 23.949 6.36773 8.3837 -46.9746 -1948 4 25.6324 38.8356 24.0083 0.522678 -6.92882 12.1803 -1949 4 25.626 39.9451 22.9935 -8.38215 2.07882 31.2615 -1950 6 10.8464 30.695 2.12273 2.92699 -11.4721 29.0623 -1951 4 9.93667 30.8598 2.41274 2.41412 3.42254 -4.79395 -1952 4 11.0072 31.0743 1.26994 -5.60296 10.8359 -22.248 -1953 6 23.0784 40.5299 40.0517 -12.8303 7.3127 -19.6888 -1954 4 23.7801 40.7079 39.3995 -2.98216 -3.06267 5.67195 -1955 4 22.2752 40.9489 39.6621 13.0026 -6.04267 8.58422 -1956 6 29.2116 28.3822 37.564 -38.7174 33.0362 -17.1388 -1957 4 28.2182 28.3913 37.3962 39.4392 -4.09178 7.25715 -1958 4 29.4217 27.5495 37.9564 8.20519 -19.4736 9.10227 -1959 6 1.867 12.1738 18.0852 -6.50713 5.08339 -35.4355 -1960 4 2.57398 11.838 18.6163 6.10024 -5.16113 22.8519 -1961 4 1.13063 12.5086 18.5994 -2.48645 -2.83143 13.3981 -1962 6 35.8305 14.0949 8.56039 26.0881 18.3061 13.156 -1963 4 35.1714 13.4739 8.88749 -16.8661 -4.96187 -13.4504 -1964 4 35.7684 14.4109 7.636 -16.9096 -16.2229 2.78164 -1965 6 9.49198 39.8165 37.5846 25.5398 -19.6342 8.10058 -1966 4 10.4488 39.5668 37.3792 -35.3087 19.1509 -1.98674 -1967 4 9.11285 40.4907 37.0027 15.1686 -3.88151 -5.41116 -1968 6 3.54864 30.3444 19.2746 19.2588 -4.84534 25.5649 -1969 4 4.39288 30.8221 19.2218 -5.35887 2.33403 -8.35831 -1970 4 3.69938 29.8 20.0823 -8.98886 6.07327 -15.723 -1971 6 36.3172 32.3761 17.5568 -52.716 -14.5505 -10.7859 -1972 4 37.1181 32.7413 17.8285 45.3049 23.5946 19.1732 -1973 4 36.5447 31.7674 16.8589 0.0557097 -8.91784 -8.34906 -1974 6 22.0674 24.5243 41.4066 13.5104 10.4808 14.5301 -1975 4 21.9193 25.2614 0.114872 1.55544 -1.48024 -5.36737 -1976 4 21.3782 24.5469 40.7428 -11.5581 2.78113 -8.36201 -1977 6 45.7659 15.6016 11.6394 9.02046 4.78635 -7.96304 -1978 4 46.6299 16.0103 11.8091 -2.50167 -1.58301 0.968075 -1979 4 45.9087 14.6499 11.5698 3.7439 -8.72722 -0.994242 -1980 6 22.3679 20.3809 16.0361 -10.6504 -17.4294 -19.3744 -1981 4 21.763 20.3139 16.7773 -4.42579 5.53693 13.3566 -1982 4 23.0073 21.0579 16.2253 11.6801 17.1208 13.2616 -1983 6 25.8325 25.7487 18.9031 6.26908 13.5994 -10.9759 -1984 4 25.2398 26.4837 18.648 3.49723 -12.6326 6.8661 -1985 4 25.3435 25.2434 19.5576 -3.6765 -3.23145 -0.768961 -1986 6 35.3178 34.202 33.2905 -17.6504 -29.1706 1.13026 -1987 4 35.3983 35.1402 33.2641 1.24044 29.706 -1.15043 -1988 4 34.4344 34.0427 33.6774 7.05439 -0.467604 -1.03347 -1989 6 39.2901 17.1075 17.3833 -11.3112 -26.2042 -1.68945 -1990 4 39.9794 17.7123 17.5836 17.425 19.0869 4.79839 -1991 4 38.575 17.6263 16.9966 -1.50153 2.1098 -0.940241 -1992 6 0.398412 14.9432 21.7856 9.03058 1.70326 -1.90296 -1993 4 54.4474 14.9193 21.5731 -3.898 -0.019948 -1.7993 -1994 4 0.528431 14.174 22.3634 -0.170355 0.861544 -0.399335 -1995 6 15.987 23.2263 17.7743 4.36624 14.6934 -7.14303 -1996 4 15.4857 22.9799 16.9684 3.82047 1.22984 7.38673 -1997 4 16.1722 24.1939 17.7179 -4.44652 -15.4901 1.96988 -1998 6 5.24865 11.1141 17.5618 6.95422 37.8037 -9.42255 -1999 4 4.73778 10.3127 17.5906 4.69561 -15.2682 10.3552 -2000 4 6.07662 11.1201 18.0866 -14.6292 -19.4463 0.240297 -2001 6 9.34435 36.7122 13.2675 14.3848 -20.4853 -8.45434 -2002 4 9.62142 35.7704 13.1913 -3.31983 12.7393 -0.467066 -2003 4 9.65952 37.1602 12.4706 -4.49166 -2.86228 3.29419 -2004 6 25.4918 33.5767 0.585194 -13.2513 47.819 -13.0434 -2005 4 25.5067 34.5261 0.924259 2.87868 -31.0124 -5.96193 -2006 4 25.9276 33.0244 1.21144 10.5779 -12.847 23.4116 -2007 6 17.3034 24.3894 31.3332 -3.83374 11.0726 -5.16798 -2008 4 17.6693 25.1812 30.9068 -1.9735 -3.85303 -0.254684 -2009 4 16.6127 24.6926 31.9382 -2.66612 -1.73239 2.61398 -2010 6 50.552 32.7161 27.7939 3.69414 -2.86079 -12.6149 -2011 4 50.6897 33.0491 28.6758 -0.144502 8.45372 13.0825 -2012 4 49.6264 32.8868 27.6344 -12.0524 -1.73095 -4.05681 -2013 6 2.253 37.2274 16.11 8.45807 0.136394 4.49883 -2014 4 3.21927 37.2459 16.107 -3.10104 -5.97474 -11.5471 -2015 4 2.06307 37.5747 16.9848 -8.61924 1.9026 3.91491 -2016 6 25.7683 33.176 8.40354 -18.9203 -11.3347 4.07551 -2017 4 24.8717 33.1921 8.8134 13.9609 -2.48357 -8.81655 -2018 4 25.7602 32.4226 7.7918 -3.67744 3.53954 1.65329 -2019 6 24.768 7.83219 25.4219 17.632 21.1734 16.2998 -2020 4 25.4945 8.36147 25.0103 -20.1597 -14.0103 5.71998 -2021 4 24.2535 7.44908 24.728 -12.2137 -5.73332 -20.4071 -2022 6 44.006 27.3325 21.546 30.1554 -7.9652 -11.3918 -2023 4 43.2457 27.8583 21.7575 -19.7371 1.57643 -2.46296 -2024 4 43.7964 26.4976 21.0884 -11.5694 12.3441 5.98804 -2025 6 20.8391 32.0716 6.72617 12.9902 -8.35788 -26.5741 -2026 4 21.6065 31.456 6.61879 -16.2643 13.1482 10.0653 -2027 4 20.6646 32.3142 7.64123 9.40483 -3.67012 8.54308 -2028 6 0.615177 26.1024 3.99379 -2.52029 5.686 8.70358 -2029 4 0.872898 25.4419 3.3518 0.34785 -8.86692 -8.8337 -2030 4 1.24928 25.9906 4.70547 -1.00806 2.16518 1.82635 -2031 6 23.6932 0.22266 22.8575 19.6208 -9.09848 8.51526 -2032 4 23.2991 1.09802 22.9795 5.26519 -2.66393 -0.960482 -2033 4 24.6108 0.216177 23.2468 -26.6208 7.90328 -9.41734 -2034 6 35.6316 26.9489 6.47476 -11.9227 4.67096 -7.07616 -2035 4 36.2784 26.7656 7.18499 -0.847143 10.2035 -9.59556 -2036 4 35.6247 27.8854 6.12936 11.6979 -23.4314 22.5499 -2037 6 50.1669 7.09081 18.6924 -7.14542 -1.6973 -3.47771 -2038 4 50.8011 7.27946 17.9805 -1.08143 -0.293524 0.841141 -2039 4 49.7425 7.94753 18.8476 4.63932 0.367722 -3.05405 -2040 6 12.4741 14.8288 12.1922 -8.10271 -9.61402 10.4649 -2041 4 11.6958 14.4794 12.6802 13.1948 7.08912 -7.97814 -2042 4 12.1183 15.3251 11.4609 -4.91784 2.70917 -6.99785 -2043 6 52.4614 22.3688 36.3388 -11.0199 -17.3524 -23.0567 -2044 4 51.6251 21.9183 36.1306 -2.17212 11.6706 13.3338 -2045 4 52.9952 21.963 35.6316 8.38603 12.1418 11.4133 -2046 6 41.778 11.4842 39.1192 -2.94788 -8.5466 -71.3066 -2047 4 42.0712 11.6935 39.9642 18.9262 14.1801 48.2999 -2048 4 42.4688 11.7778 38.472 -13.5225 -5.5757 18.7019 -2049 6 13.7869 22.5139 39.1025 -32.0544 -7.10206 -10.9841 -2050 4 12.8164 22.2898 39.2995 40.1723 6.0649 -15.4789 -2051 4 14.0276 22.2847 38.1645 -11.932 2.241 24.8997 -2052 6 28.7471 19.519 21.8427 26.201 -31.4587 -3.42241 -2053 4 29.5077 18.8642 21.7553 -27.3151 19.4313 7.21597 -2054 4 28.709 19.939 20.977 -1.33904 3.86677 -3.41873 -2055 6 8.35104 21.6464 36.3873 -9.70021 11.1463 1.78198 -2056 4 8.59231 22.5715 36.3877 5.92817 6.74417 -5.91108 -2057 4 7.6521 21.6323 37.0621 1.10663 -7.27579 -5.05072 -2058 6 39.9466 23.9759 15.2079 21.5993 -7.98015 -41.1742 -2059 4 40.8727 23.6245 15.2724 -23.8836 11.1149 -0.884493 -2060 4 39.7538 23.9548 14.2182 -0.675121 3.14563 34.0025 -2061 6 8.14826 38.6974 22.5407 10.5164 -8.10765 28.5856 -2062 4 7.68497 39.3831 22.0542 -4.5186 11.15 0.90042 -2063 4 8.43687 39.0737 23.4204 -11.1896 -2.29822 -22.518 -2064 6 10.8609 20.1732 28.9608 12.8413 -0.923384 7.34695 -2065 4 10.0131 19.7426 29.0637 -5.9523 -4.47565 4.1188 -2066 4 10.8844 20.5008 28.0696 -0.703946 5.19258 -12.1525 -2067 6 36.9008 23.822 41.8156 -12.4363 21.7846 -10.0393 -2068 4 37.5711 23.2333 0.167128 40.9996 -19.7248 12.2972 -2069 4 36.1173 23.3131 41.9445 -23.6506 -5.40851 2.0223 -2070 6 23.7894 40.6868 33.3454 12.8596 -15.6087 -7.6142 -2071 4 23.0064 40.9655 33.8068 -12.9523 11.6172 4.83708 -2072 4 23.8763 39.7481 33.6232 3.5481 12.5289 -6.50269 -2073 6 4.67002 19.3025 35.4081 28.9654 -8.37802 15.8464 -2074 4 5.50304 19.0977 35.9037 -20.926 10.8248 -6.78781 -2075 4 4.54874 18.5079 34.879 -7.50763 -2.93955 -6.02594 -2076 6 9.44906 25.7726 10.897 4.32597 -4.58851 8.60165 -2077 4 9.18995 24.8319 10.8983 -5.5655 4.98255 -0.925486 -2078 4 8.69969 26.3126 10.6078 0.159443 -6.7376 0.514864 -2079 6 27.2776 22.4912 13.6121 -0.517147 -7.99313 -8.85992 -2080 4 27.155 21.7331 14.2088 0.0551372 2.14825 -2.63665 -2081 4 27.5226 22.1158 12.7439 -1.12325 6.52643 14.1544 -2082 6 41.0473 18.7721 23.2805 -1.65607 -7.19044 -7.91226 -2083 4 40.4257 18.2083 22.8124 7.09703 -3.21037 0.549063 -2084 4 40.4899 19.4448 23.6465 -2.2525 13.4867 10.2584 -2085 6 46.4847 28.3568 20.1596 21.4343 7.62243 20.4812 -2086 4 45.6558 28.0725 20.6313 23.6124 6.3397 2.68094 -2087 4 47.3103 28.4552 20.7557 -43.4876 -6.08109 -17.1535 -2088 6 14.856 15.3945 30.0569 12.1054 -1.48105 24.8406 -2089 4 14.6669 15.4041 29.1302 -8.67008 -4.83168 -20.7775 -2090 4 14.3859 14.629 30.4429 4.17574 5.50589 -6.96103 -2091 6 23.5299 24.7674 35.2089 8.01546 19.7663 24.3744 -2092 4 22.8065 25.3632 35.4756 2.8295 -9.26237 -7.23473 -2093 4 24.1647 24.8645 35.9517 -5.58112 -4.18239 -8.07128 -2094 6 19.8979 24.2128 28.4372 -8.55524 33.371 -10.5251 -2095 4 20.118 25.106 28.0235 -7.554 -30.7898 14.4583 -2096 4 18.9386 24.2465 28.5992 8.91169 -0.342387 -2.75065 -2097 6 45.9653 7.62821 20.2375 0.645938 -6.46631 40.9505 -2098 4 46.1455 7.81465 21.2011 -4.75538 -9.14986 -26.6761 -2099 4 46.2053 8.42523 19.7798 3.02803 13.7202 -10.1214 -2100 6 38.0274 12.476 8.2804 -12.7973 12.3245 -4.6187 -2101 4 37.3544 13.1993 8.5286 18.4233 -41.2645 -20.6098 -2102 4 37.689 11.8001 7.60922 -1.16355 31.2483 23.3325 -2103 6 46.9232 18.1908 8.45127 -20.6048 6.85227 14.7641 -2104 4 46.2435 17.4987 8.55233 4.56757 4.50302 -0.225601 -2105 4 47.4224 17.9381 7.68168 11.4282 -5.99968 -17.9171 -2106 6 10.854 13.9656 9.37577 10.6617 18.3473 -18.9154 -2107 4 10.3554 14.661 8.90618 -4.87744 -10.6328 11.7585 -2108 4 11.7492 14.0754 8.99486 -7.79483 -7.36366 10.4335 -2109 6 34.413 5.42618 14.0852 -12.6861 0.159125 26.6885 -2110 4 35.1199 5.9296 13.6715 10.4361 -4.78744 -13.6438 -2111 4 34.2786 4.53955 13.7091 11.464 2.02167 -7.62295 -2112 6 0.18261 0.234369 22.9555 2.77695 -16.1069 -0.480131 -2113 4 0.268342 41.6651 22.1144 -0.0234796 4.94264 7.55149 -2114 4 54.831 1.09037 22.7433 -8.12427 18.964 -5.90735 -2115 6 40.9343 30.5497 37.8912 -0.822728 -5.40818 -2.29365 -2116 4 40.0406 30.8803 38.1728 23.6728 -16.1598 5.2797 -2117 4 41.3254 29.8415 38.4693 -14.8835 20.0143 -6.13723 -2118 6 16.6534 17.3205 12.6874 14.7099 15.3782 -9.06546 -2119 4 16.1954 16.505 12.4572 -1.18797 -4.10455 -0.493236 -2120 4 17.006 17.6533 11.8352 -5.05849 -6.69802 12.8635 -2121 6 29.6898 5.4323 24.749 -0.0153423 -4.79708 -9.00604 -2122 4 30.3311 5.93507 24.2276 2.5605 1.293 3.45927 -2123 4 29.9547 5.54756 25.6733 0.859724 2.70473 -2.20341 -2124 6 49.8976 0.279 27.2063 11.3554 -10.6099 9.68168 -2125 4 49.8114 0.578981 26.2935 2.75523 0.634109 -3.06626 -2126 4 50.8097 41.8349 27.2847 -10.6363 5.42595 -5.44518 -2127 6 31.2372 31.739 15.2138 3.99594 22.7956 -4.27207 -2128 4 31.6256 30.8953 15.4507 4.79789 -4.71254 6.82751 -2129 4 31.9624 32.4004 15.1381 -14.4355 -14.737 3.33184 -2130 6 35.7805 24.1465 16.9504 11.9916 -3.59376 -8.04525 -2131 4 35.6914 24.9231 16.3572 2.28972 -11.6943 5.94213 -2132 4 36.6882 23.763 16.8157 -19.8391 7.30154 4.46135 -2133 6 24.2601 4.62781 36.7306 -2.73038 -12.1142 -21.0154 -2134 4 24.8177 5.17448 37.2794 5.25293 5.76293 7.44764 -2135 4 24.6802 4.67277 35.8537 -9.35577 -2.69704 9.81341 -2136 6 17.5719 12.8989 3.66466 27.7221 -13.8379 -12.2911 -2137 4 17.7111 13.5231 2.92461 -8.26776 -5.83385 13.2655 -2138 4 16.7968 13.1561 4.15408 -15.8703 8.33112 4.7305 -2139 6 4.16771 14.2922 18.2601 -1.91899 -29.1082 -10.1028 -2140 4 4.22837 13.3107 18.2109 4.90834 19.7408 -0.578384 -2141 4 3.27435 14.4381 18.5824 -9.9871 6.86755 4.44487 -2142 6 19.1699 36.8381 22.3902 -4.55286 10.0742 -5.97046 -2143 4 18.832 36.3461 23.1414 -4.92402 -9.67799 11.164 -2144 4 19.5712 36.1952 21.8056 6.33502 -12.5333 -3.55186 -2145 6 15.653 11.96 13.2084 19.351 18.6963 0.185202 -2146 4 15.6609 12.833 12.7547 -2.35489 -19.4305 9.56752 -2147 4 16.5767 11.8359 13.5469 -18.24 -1.16426 -6.81767 -2148 6 24.7461 21.9204 5.38797 -27.1503 3.38708 1.08719 -2149 4 25.0422 21.7466 6.29562 -9.42613 0.489783 0.293639 -2150 4 23.7615 21.7936 5.33342 31.5349 -1.60743 10.1723 -2151 6 52.731 18.5617 35.2291 -23.3227 -9.96089 -3.35821 -2152 4 52.3432 18.0885 34.4925 12.0283 -8.22578 -16.7439 -2153 4 51.9379 18.6142 35.7503 -4.18579 12.1235 24.3517 -2154 6 3.56339 27.2782 25.2861 -13.9068 -17.971 -11.9546 -2155 4 3.93933 27.1708 26.1554 6.48024 -2.07304 15.4908 -2156 4 3.97283 28.0403 24.8958 8.97188 17.1762 -5.24442 -2157 6 34.4703 32.9949 30.674 6.71734 26.132 41.1649 -2158 4 33.5303 32.9277 30.8218 -10.267 -13.4259 -20.1884 -2159 4 34.6757 33.5653 31.4552 13.6938 -14.1125 -21.2315 -2160 6 35.2703 23.7477 9.841 1.59588 4.98779 0.126485 -2161 4 34.557 23.9691 9.22977 0.987563 3.83206 0.754652 -2162 4 35.6213 22.923 9.5082 6.82753 -10.3388 -1.5208 -2163 6 42.4139 15.7114 8.97964 24.1102 0.334397 4.42901 -2164 4 41.6569 15.4185 8.4899 -23.1764 -3.9339 -8.15459 -2165 4 42.1019 15.9745 9.85446 -9.30455 -0.897043 1.06511 -2166 6 7.76859 28.8573 32.9442 -15.9037 16.0354 -10.4898 -2167 4 7.97908 28.1549 33.5519 6.36032 -10.9608 11.0673 -2168 4 8.54203 29.0732 32.4131 7.8922 -1.0693 -1.41065 -2169 6 17.6887 41.2397 36.4833 -13.2152 -10.2381 33.1554 -2170 4 16.9194 41.8027 36.6113 -2.7651 1.17246 3.809 -2171 4 17.9462 41.408 35.602 16.1966 5.46369 -29.7656 -2172 6 28.4973 24.2486 15.5471 -12.6583 -10.112 -30.4241 -2173 4 29.1017 24.9078 15.1992 6.65529 6.29726 4.69488 -2174 4 28.2904 23.7156 14.7389 1.39534 3.17619 21.4563 -2175 6 20.9519 16.2974 1.15248 44.1264 9.982 -6.69009 -2176 4 20.9895 15.4004 1.43432 -0.0798072 -22.9414 11.198 -2177 4 20.0538 16.5254 1.09156 -44.6028 7.62895 -2.50253 -2178 6 31.1717 40.7384 5.29995 -1.14335 -24.9234 -14.6262 -2179 4 30.3101 40.4535 4.98914 0.542473 -7.39845 -0.335603 -2180 4 31.0069 41.6267 5.54556 -2.10438 36.1837 12.2935 -2181 6 29.9172 24.7601 36.4536 2.52587 12.7881 -5.39704 -2182 4 30.4095 25.4459 35.9567 -7.35112 -4.48214 8.13095 -2183 4 30.0744 23.9625 35.9621 2.47343 -16.947 -5.4104 -2184 6 8.66853 31.0461 3.90506 3.77884 -22.5587 -9.29968 -2185 4 7.73756 30.8263 3.92016 -7.28297 1.54323 -1.95967 -2186 4 8.75192 31.9258 4.24445 1.80419 26.3875 10.0131 -2187 6 5.53845 32.6958 11.4143 8.71933 -16.8124 -2.49586 -2188 4 4.77303 33.2403 11.6664 3.11219 -11.1916 -2.75881 -2189 4 5.22904 31.759 11.32 0.456358 25.4252 4.80969 -2190 6 45.6505 35.4572 20.4414 3.44959 -7.44503 -2.03407 -2191 4 45.0984 35.4295 19.6379 6.4013 -0.712815 7.57821 -2192 4 46.1919 34.6303 20.4513 -12.6908 13.7486 -3.45541 -2193 6 19.5117 2.78375 9.7759 -32.3978 -9.59039 -17.0694 -2194 4 19.2358 3.70482 9.71872 -0.134373 3.8207 4.89971 -2195 4 18.7417 2.29322 9.36028 25.7327 11.9734 13.3495 -2196 6 54.9587 9.07031 10.9149 6.82732 -5.63024 12.2566 -2197 4 54.8294 8.9199 11.8667 -4.4018 -2.06217 -5.32285 -2198 4 0.663346 9.73371 10.8556 1.49355 -0.124783 -2.42855 -2199 6 21.0387 26.5729 14.7801 20.1883 -1.49652 -44.4677 -2200 4 21.3075 26.2685 13.8316 -13.9911 15.8829 47.28 -2201 4 20.1009 26.3915 14.9175 1.72514 -4.1332 -5.78598 -2202 6 14.1556 30.5195 27.5512 33.9559 3.86758 5.7066 -2203 4 14.6157 30.1887 28.3748 -9.20473 8.28645 -28.3289 -2204 4 14.8625 30.9321 26.9648 -24.7422 -11.1229 20.6028 -2205 6 29.8153 17.3336 31.0863 -17.242 12.2647 2.89366 -2206 4 30.6608 17.508 30.6961 22.1461 -2.37775 -6.86255 -2207 4 29.3509 18.1813 30.9961 -0.156979 -6.11616 8.89085 -2208 6 50.8803 17.2897 27.8178 -36.3925 19.5692 4.68662 -2209 4 49.966 17.6961 27.8739 30.6942 -17.822 -8.40051 -2210 4 51.3989 17.8346 28.4178 4.99425 -5.86793 -0.268148 -2211 6 46.2649 37.0836 13.9834 -5.2064 -3.89214 -29.9265 -2212 4 46.1297 37.5324 14.8008 -1.4234 12.1478 29.9589 -2213 4 45.6025 37.4999 13.3985 5.55615 -7.46483 0.310394 -2214 6 38.1938 37.2652 33.1426 -7.30823 -21.5307 12.8964 -2215 4 38.5245 37.3061 34.0621 0.43181 3.22683 -10.2889 -2216 4 38.5338 38.0078 32.6437 8.99657 15.0472 -1.17828 -2217 6 41.835 13.3432 31.1173 -10.6585 13.9874 21.8211 -2218 4 41.5818 13.8647 31.919 4.55225 -14.0949 -20.2689 -2219 4 42.3932 12.6177 31.4161 6.34511 -7.13184 -1.29627 -2220 6 46.8964 12.6581 17.833 -7.85032 10.4907 -16.4819 -2221 4 46.6484 13.6178 17.7542 4.08188 -24.8978 -7.40371 -2222 4 46.6377 12.1709 16.9987 5.46876 16.7046 19.0746 -2223 6 32.0579 10.0934 10.6503 -8.64381 28.9058 -4.43215 -2224 4 31.7849 9.65569 11.4853 0.173068 15.3159 -11.0765 -2225 4 31.7767 11.0763 10.6467 12.4785 -48.8318 10.7993 -2226 6 34.0094 11.373 6.75969 12.8388 24.8548 11.4886 -2227 4 33.4875 10.5861 6.69386 -15.1181 -21.0438 1.83339 -2228 4 33.7853 11.7772 7.62543 1.85262 -6.17932 -11.7084 -2229 6 45.3294 30.8612 19.494 8.3992 -12.4908 2.66791 -2230 4 45.3133 30.6326 20.4263 -2.2594 2.91399 10.7741 -2231 4 45.8271 30.1094 19.1443 -2.81922 5.63857 -5.34771 -2232 6 20.3557 0.57205 7.14927 -0.865045 4.87397 8.36509 -2233 4 20.1887 0.590785 8.10086 -2.30268 5.48708 -2.96522 -2234 4 20.2885 41.5556 6.94299 -1.24307 -13.5357 -7.1472 -2235 6 15.9783 39.4524 4.13892 -0.0151964 -9.48015 -5.29824 -2236 4 15.6158 39.9898 3.41173 1.6648 1.85694 12.5404 -2237 4 15.64 39.7774 4.99485 -4.20756 5.15612 -10.0141 -2238 6 52.4256 16.4667 25.1127 -17.0507 13.8269 -2.02364 -2239 4 51.8848 16.9346 25.7614 0.982734 -7.60925 5.82434 -2240 4 52.3383 17.0704 24.353 8.48557 -12.5426 -0.219872 -2241 6 38.5361 13.0039 3.23845 15.1533 54.069 38.768 -2242 4 38.651 13.64 4.04305 -2.16968 -28.4467 -44.0011 -2243 4 38.0019 12.309 3.58724 -16.6469 -22.8542 0.297491 -2244 6 35.13 29.6899 31.1766 -32.8294 1.63854 50.8714 -2245 4 35.4825 30.1651 30.4465 16.0479 15.276 -26.3528 -2246 4 34.6741 30.3613 31.7643 12.1102 -21.125 -19.7306 -2247 6 9.51973 33.7498 4.86217 -21.8826 5.77433 4.68556 -2248 4 9.27059 34.3826 5.57285 8.50621 -13.5655 -12.6408 -2249 4 10.3866 33.3952 5.041 8.90701 -1.44023 3.12186 -2250 6 21.534 22.0642 20.5279 -11.3341 -5.53839 17.2976 -2251 4 20.8989 22.7675 20.339 3.51908 1.76985 -0.685914 -2252 4 21.3133 21.7346 21.437 6.74336 6.48682 -22.5749 -2253 6 37.579 11.1901 41.2936 -40.5688 -13.8213 19.6839 -2254 4 37.9154 11.8125 40.6731 20.8822 18.4609 -22.3708 -2255 4 38.2848 10.6639 41.6667 19.2795 -3.39896 1.21846 -2256 6 33.8862 1.42431 38.7362 -9.76991 -12.243 -0.11253 -2257 4 33.6023 0.553369 38.4181 2.20193 5.31751 1.25532 -2258 4 33.9041 1.3558 39.7008 -0.574955 5.51976 -3.65617 -2259 6 4.57166 26.6812 27.9899 28.8485 -45.5436 -4.48952 -2260 4 5.15229 25.8908 28.1565 -23.3183 20.9594 -13.553 -2261 4 4.90489 27.293 28.6243 -0.866291 24.6335 11.5543 -2262 6 10.2514 0.902381 11.6154 -4.58149 -17.6537 26.8062 -2263 4 10.6592 1.12475 12.4668 -4.26503 -7.612 -8.38981 -2264 4 10.5004 1.60734 11.0484 5.83944 23.9466 -26.0443 -2265 6 17.6545 19.8255 2.35686 18.7122 -0.118329 6.29025 -2266 4 17.9031 20.43 1.64019 0.754008 -4.0492 2.7955 -2267 4 18.4832 19.3436 2.60738 -15.0404 10.1651 -4.64219 -2268 6 32.418 25.6758 16.4635 3.6076 24.4214 11.9097 -2269 4 33.0171 26.0095 17.1449 -9.06157 4.09224 -4.99535 -2270 4 32.7904 24.838 16.2462 -1.14602 -28.0291 -11.1265 -2271 6 33.2468 10.6359 0.32388 9.93322 -26.76 -6.12289 -2272 4 32.8861 10.0042 41.5485 10.341 19.2926 16.9559 -2273 4 34.0854 10.2367 0.697563 -23.7256 11.8288 -10.1734 -2274 6 4.94758 4.52061 10.1416 10.7499 4.98188 17.9077 -2275 4 4.04768 4.863 10.1726 -0.273394 -4.88493 2.42241 -2276 4 5.29522 4.53942 11.0694 -10.4701 1.63881 -23.2648 -2277 6 27.0943 16.9779 9.5563 -20.4641 3.47693 -11.2288 -2278 4 27.2045 17.5151 10.3493 -1.38601 2.5137 2.70549 -2279 4 26.2214 17.2494 9.17658 21.4447 -4.2653 12.7286 -2280 6 9.99194 10.5198 19.3763 9.42123 -1.05348 44.8422 -2281 4 10.4342 9.89794 18.8118 9.85784 -12.5922 -17.5865 -2282 4 10.1605 10.162 20.3013 -9.67835 15.4527 -31.558 -2283 6 19.5738 8.53792 27.8563 25.8928 -1.13542 15.4327 -2284 4 20.113 8.77024 28.6584 -12.6361 -5.62488 -23.922 -2285 4 20.1113 7.87775 27.3567 -13.5748 14.3815 9.08869 -2286 6 47.0629 38.9588 23.1271 -13.9792 1.44752 0.432651 -2287 4 47.6691 38.8737 22.3925 4.22694 -4.47738 -4.61135 -2288 4 46.1776 38.8683 22.7344 3.33277 3.24373 3.79368 -2289 6 19.6833 25.3678 11.2608 -44.4501 -0.725843 0.650565 -2290 4 19.0139 24.6272 11.3182 24.6346 19.551 -2.60477 -2291 4 19.1544 26.1629 11.5326 10.4738 -19.1562 -5.87093 -2292 6 27.3884 13.4531 15.7313 17.4935 -10.3398 7.87305 -2293 4 26.7289 13.8255 16.2909 -22.225 11.7393 10.4827 -2294 4 28.1076 13.2654 16.3619 5.43008 -3.78237 -14.8549 -2295 6 18.6476 14.1287 1.42435 5.12245 -4.46092 -43.403 -2296 4 18.3969 15.043 1.25229 -6.07889 7.26273 6.76186 -2297 4 19.169 13.9274 0.593091 -12.995 -1.5013 29.2583 -2298 6 42.2956 22.0175 32.4812 -31.5033 5.69606 -11.9689 -2299 4 42.0953 21.6028 33.3343 -5.26012 -0.0861087 1.91793 -2300 4 41.4492 22.4721 32.2087 27.3869 -15.7461 8.96812 -2301 6 10.0338 9.4525 2.5044 21.0744 -25.1182 9.26795 -2302 4 9.23419 9.82009 2.8603 -22.4046 15.9317 4.21557 -2303 4 10.2146 8.68383 3.09556 -0.513225 11.8796 -14.6695 -2304 6 6.81454 1.43994 21.9965 -17.8896 2.42247 -7.4431 -2305 4 5.91626 1.63042 21.618 24.8197 -16.2049 7.25345 -2306 4 7.09146 0.513113 21.8391 -15.5061 11.1514 -4.64506 -2307 6 11.279 27.0428 18.9739 -2.94846 37.5248 -0.887691 -2308 4 11.8405 27.0241 19.773 -2.49358 0.901506 -7.48985 -2309 4 11.2189 28.0198 18.7087 3.35633 -32.7966 13.2637 -2310 6 41.4624 20.5117 27.2131 -8.71247 23.609 -19.3396 -2311 4 41.6397 21.203 27.8749 -2.09795 -12.5822 -0.139714 -2312 4 41.4581 19.6661 27.6488 3.25287 -9.08293 14.2442 -2313 6 15.4472 24.107 33.4286 7.47915 5.78269 -2.8589 -2314 4 14.6947 24.3175 34.0087 6.10264 -6.26217 -2.67023 -2315 4 15.704 23.1687 33.5026 -8.54671 4.87938 10.939 -2316 6 36.1332 16.3778 10.0175 -2.81296 8.13669 8.31829 -2317 4 36.0433 15.4982 9.63146 0.0153009 -3.05325 1.23302 -2318 4 36.1908 16.2895 10.9807 1.05799 -3.5475 -8.17119 -2319 6 51.7056 16.2618 2.12066 8.195 -18.8618 -27.7488 -2320 4 51.3212 16.7491 2.82948 -13.5116 6.32013 30.1636 -2321 4 51.8333 15.3227 2.36395 -2.62212 15.8907 6.5854 -2322 6 23.4154 8.54771 39.774 19.4785 -4.07885 -14.0827 -2323 4 23.6619 8.92799 38.8876 -4.40964 -10.2511 30.1282 -2324 4 24.1933 8.06554 40.1323 -10.8686 15.1901 -10.9325 -2325 6 36.7652 34.4407 21.0996 -10.7203 -4.0633 -8.35763 -2326 4 37.1575 34.5988 20.2292 -2.24352 0.118594 1.89686 -2327 4 35.7922 34.4168 20.9564 13.0606 -0.027129 3.88767 -2328 6 14.1394 8.88964 27.2822 8.4001 33.0473 -16.3093 -2329 4 13.5583 8.17177 27.4325 -25.1847 -27.8879 6.89622 -2330 4 14.9981 8.62308 27.6007 12.278 -0.771553 4.38 -2331 6 20.6523 37.4857 25.1916 -4.76336 -9.80096 2.89409 -2332 4 20.8435 36.6327 24.7231 -2.60537 24.8018 1.29013 -2333 4 20.5883 38.2205 24.557 2.95927 -14.0914 0.587832 -2334 6 28.8259 24.466 30.0361 -12.0182 1.20484 18.6414 -2335 4 28.1863 24.5363 29.306 15.5663 0.0495978 -2.57679 -2336 4 29.6571 24.0617 29.7579 -0.701354 -5.27936 -13.535 -2337 6 8.3767 11.9994 23.6977 15.286 -11.9681 20.7139 -2338 4 9.3753 12.0245 23.8359 -31.6027 -4.22616 -3.50543 -2339 4 7.96209 11.4264 24.4013 16.8905 14.3689 -13.5243 -2340 6 16.0974 26.6628 22.9497 0.767107 4.93659 2.67852 -2341 4 16.422 25.9025 22.452 -4.69466 0.466105 1.02544 -2342 4 15.3072 26.4353 23.4595 5.90508 -1.9072 -2.1838 -2343 6 22.3492 41.3933 9.48833 17.1541 -15.2597 3.14364 -2344 4 22.6076 0.330473 9.13574 5.89797 15.5422 -4.87712 -2345 4 21.4389 41.4869 9.73785 -21.2641 2.73615 1.78898 -2346 6 49.3865 19.1849 32.379 28.5034 -27.5288 -8.8444 -2347 4 49.9591 18.5119 32.8294 -20.0237 22.3317 -7.01358 -2348 4 48.8882 19.6696 33.032 -5.7885 3.32597 15.4548 -2349 6 29.6797 28.4194 31.2347 -18.17 -6.54897 12.3532 -2350 4 30.6054 28.3362 30.9452 0.112823 -13.8933 8.50124 -2351 4 29.3632 27.6339 31.7874 27.6893 19.0339 -22.4607 -2352 6 5.1089 39.1304 23.5821 16.3589 -26.7425 38.52 -2353 4 5.38369 38.72 24.4786 -14.1195 25.2427 -41.8592 -2354 4 5.12138 40.0884 23.679 1.29424 5.88982 9.05127 -2355 6 42.9406 13.5828 41.5963 2.4548 -20.3274 5.45752 -2356 4 42.752 14.3543 41.1051 4.71299 30.6973 -25.311 -2357 4 42.1302 13.4831 0.159852 -12.9765 -12.2431 17.3873 -2358 6 21.226 12.4267 7.36435 31.2446 -3.521 -2.03074 -2359 4 20.2961 12.4647 7.18572 -19.4619 -2.59914 -12.879 -2360 4 21.5838 11.6146 6.96487 -5.92297 6.31526 1.33966 -2361 6 43.1402 26.8798 37.6925 36.8226 -18.0871 25.2922 -2362 4 42.3701 26.4861 37.2457 1.92095 -10.9538 3.42147 -2363 4 43.8051 26.2366 38.1772 -44.9135 25.1765 -29.4158 -2364 6 19.5374 10.6589 41.6895 -5.57828 -38.0023 -10.1688 -2365 4 19.1336 10.6448 0.637369 -6.5477 2.89313 17.0607 -2366 4 19.8005 11.5407 41.5226 10.6711 39.664 -4.3781 -2367 6 53.6211 10.0725 3.2523 6.57913 5.47914 -9.18923 -2368 4 54.2317 10.83 3.34927 -4.54537 -9.93589 0.0420736 -2369 4 54.0384 9.44833 2.62164 -2.29754 8.8252 9.03809 -2370 6 17.5636 20.1992 28.4305 -16.5699 17.1528 15.5915 -2371 4 18.0548 19.7019 27.7957 9.40873 -10.9714 -15.8242 -2372 4 18.1497 20.2955 29.1876 1.50874 1.07066 2.83373 -2373 6 36.8673 7.33814 1.69171 -42.7001 9.70605 -8.47937 -2374 4 37.6788 7.60022 2.09727 18.2611 10.2246 9.26811 -2375 4 36.4242 8.16776 1.39628 11.5951 -12.345 5.16871 -2376 6 29.225 41.4226 1.83075 -19.1389 21.107 -1.05665 -2377 4 28.4254 0.0289368 2.09685 16.3458 -11.1471 3.47601 -2378 4 29.1672 41.4088 0.871311 7.531 -2.47214 -5.14574 -2379 6 13.5148 3.09025 8.11784 -10.8355 13.5741 -3.86075 -2380 4 12.8447 3.80664 8.08285 8.27234 -10.6709 -2.48032 -2381 4 13.8247 3.09872 9.02804 1.30446 -5.60755 1.07776 -2382 6 15.035 29.5824 18.5052 -13.3664 3.09019 -9.07378 -2383 4 14.628 28.8743 17.9722 6.78876 3.62049 6.93265 -2384 4 14.2975 30.1967 18.6986 12.8362 -2.82157 -1.1162 -2385 6 10.5118 24.7077 24.3903 18.3301 23.9761 -31.3173 -2386 4 10.707 24.7057 23.4146 -4.2845 7.89501 28.372 -2387 4 10.0612 23.8909 24.4849 -17.9274 -27.8 13.6507 -2388 6 2.3293 13.8562 25.1542 8.14415 -2.44132 2.05706 -2389 4 1.63302 13.4321 24.6436 -3.32338 -7.08116 -5.4939 -2390 4 2.0923 14.7815 25.112 -7.52471 9.11743 -0.122921 -2391 6 31.8571 32.759 29.7983 3.65167 10.3578 -8.56752 -2392 4 30.9277 32.9381 29.9784 -0.622435 -3.80813 0.732423 -2393 4 31.8884 31.8723 29.4276 -3.71181 -5.10697 -2.58235 -2394 6 37.531 40.8209 33.967 -23.153 -16.1875 5.3836 -2395 4 37.3251 40.1347 34.6985 0.870468 26.6491 -35.3147 -2396 4 36.773 40.8784 33.3102 18.3716 -9.25033 25.8989 -2397 6 24.0485 38.1313 34.3431 -11.5105 1.837 -35.773 -2398 4 24.1907 38.198 35.2802 9.24451 -7.73664 19.5979 -2399 4 24.4675 37.3552 33.934 1.62169 3.10325 14.1331 -2400 6 37.1852 22.5711 7.36841 5.54302 -17.8805 15.7599 -2401 4 37.6193 21.7136 7.5635 -9.24307 15.2983 -3.07678 -2402 4 37.2973 22.7156 6.43503 3.10694 -1.55352 -15.3513 -2403 6 4.30637 23.241 35.6005 -21.8515 -3.12039 0.833232 -2404 4 4.28153 22.3978 35.1252 -1.17938 4.50836 1.52069 -2405 4 3.36633 23.5034 35.7569 13.5984 -2.36814 -1.35472 -2406 6 15.7372 14.8984 2.68389 5.83394 8.18523 30.6602 -2407 4 16.0581 15.8209 2.80401 -5.66096 -17.7803 -6.78984 -2408 4 15.4195 14.7671 1.79524 0.865375 8.28049 -11.4308 -2409 6 48.1667 23.1873 2.04358 2.14857 -5.2771 -14.5053 -2410 4 48.6748 23.4267 2.82287 11.4848 0.866046 3.26637 -2411 4 48.7964 22.9219 1.32588 -13.3162 5.875 14.6145 -2412 6 24.1221 19.9752 21.5371 -32.3717 23.6383 6.86593 -2413 4 24.143 19.3917 22.3107 11.6246 -2.80692 -10.3828 -2414 4 24.7866 19.7762 20.8968 22.5091 -14.1667 -7.68302 -2415 6 10.5822 29.3968 5.14403 -6.21678 -11.6361 15.7318 -2416 4 9.83188 29.7897 4.67624 10.1791 9.93667 -6.35089 -2417 4 11.4324 29.7717 4.90568 -2.60747 8.99296 -10.7541 -2418 6 5.96985 27.6957 31.2251 14.0826 -21.4471 -14.909 -2419 4 6.62108 27.1001 30.7651 -15.2176 13.0885 7.83628 -2420 4 6.49554 28.1541 31.8886 3.5811 4.10899 4.91189 -2421 6 18.524 25.7945 15.3346 -6.80319 -1.26411 -41.3947 -2422 4 18.3129 25.8537 16.2191 -1.03447 -6.47723 71.4836 -2423 4 17.8509 26.3975 15.0287 -5.96066 9.61194 -22.438 -2424 6 52.0911 37.2147 11.1191 10.7944 -12.7592 -3.2574 -2425 4 52.6735 36.5031 10.7991 -6.06835 6.24709 5.19982 -2426 4 52.6754 37.9802 11.2539 -6.64808 -1.57102 -0.449092 -2427 6 46.8545 14.6154 7.32174 -10.4102 9.08531 6.17155 -2428 4 46.1761 15.2305 7.76384 29.9054 -34.6086 -7.32766 -2429 4 47.196 13.9114 7.91569 -13.0839 18.0399 0.731203 -2430 6 22.2426 0.701706 41.6733 41.1626 12.534 -29.9538 -2431 4 22.236 1.66756 41.6378 -9.79705 -6.68715 4.90956 -2432 4 23.0808 0.492341 41.1545 -29.2322 -0.545859 23.5967 -2433 6 4.06645 14.7285 9.26505 -5.79968 22.7562 -12.5209 -2434 4 3.53709 15.5501 9.07402 9.13976 -21.8289 3.48331 -2435 4 4.94549 14.9564 8.94351 2.1847 -1.50717 0.750146 -2436 6 37.293 12.6643 37.0348 -15.3153 -6.18171 16.0178 -2437 4 37.7524 12.8164 37.9019 -17.8573 -2.14895 -9.99561 -2438 4 36.3666 12.3049 37.1727 33.7628 8.85249 1.83374 -2439 6 26.6624 29.0693 40.5955 -26.637 27.4899 13.7151 -2440 4 27.0962 28.2693 40.8235 19.1059 -29.7051 -2.9078 -2441 4 26.7436 29.2635 39.6647 9.93266 -1.33043 -11.4317 -2442 6 7.23743 13.8563 3.32048 -33.1041 -30.3754 -14.41 -2443 4 7.96064 14.4301 3.56742 25.5688 -7.52041 0.820923 -2444 4 7.42976 12.8854 3.09984 6.81051 43.2082 15.4509 -2445 6 8.94797 34.8532 28.8254 23.4184 -23.2786 -12.4265 -2446 4 9.89546 35.0323 28.6727 -12.7097 -5.00209 3.03018 -2447 4 8.59604 35.6886 29.0779 -14.3686 23.8739 12.2374 -2448 6 37.2014 40.0808 40.1141 12.7521 0.43192 13.6168 -2449 4 36.2619 40.0837 39.9632 -10.4254 2.72875 -6.67898 -2450 4 37.248 39.4512 40.8496 7.71934 0.19736 -2.65382 -2451 6 30.3728 6.17428 27.2502 2.34222 12.9127 24.6773 -2452 4 30.0491 5.75377 28.1093 17.5599 21.8776 -23.7977 -2453 4 31.0277 6.90628 27.4549 -18.5498 -22.5685 3.02853 -2454 6 10.4851 22.8816 18.2947 -6.39025 -14.7202 -25.3901 -2455 4 11.3539 23.0451 18.66 8.78619 -1.44678 0.615593 -2456 4 10.601 22.3432 17.4702 -0.435219 15.7289 22.4338 -2457 6 35.9047 14.2516 40.1476 -11.9566 8.08227 -8.12446 -2458 4 35.3828 14.5983 39.4171 17.9635 11.5828 -3.36223 -2459 4 35.2535 13.6726 40.504 -8.36759 -16.975 21.7169 -2460 6 6.70775 1.0715 17.7189 7.50642 -21.2746 -7.36561 -2461 4 6.22784 1.34485 18.5084 1.44497 -10.5234 3.95628 -2462 4 6.91772 0.0894674 17.7256 -13.4419 30.1572 13.7277 -2463 6 41.3365 34.0623 33.1636 23.1157 -5.84267 13.8333 -2464 4 40.4227 34.234 32.9444 -15.3258 11.3352 -14.6542 -2465 4 41.9184 34.5849 32.5841 -12.4833 3.91505 -3.84565 -2466 6 37.2858 0.99342 41.2878 7.36827 13.3221 -16.8172 -2467 4 37.4859 0.112276 40.9658 -1.88555 -12.2628 0.361589 -2468 4 37.4834 1.0172 0.312287 5.29267 -3.40266 15.6364 -2469 6 25.2541 30.9749 6.2071 -22.7336 2.5299 17.3506 -2470 4 26.0217 31.2424 5.69829 1.89843 -3.96463 -15.2281 -2471 4 24.4182 30.8551 5.69564 23.045 5.74277 3.20871 -2472 6 14.1871 24.4929 28.313 -6.35756 40.4048 -1.58139 -2473 4 14.3311 23.6816 28.7714 -3.10946 -31.1704 -0.0360927 -2474 4 13.792 24.4319 27.4273 2.40698 -14.1025 6.50138 -2475 6 34.2078 26.2332 36.0169 -41.3887 31.6455 20.302 -2476 4 35.1375 26.2713 36.1926 18.3831 1.21525 6.50399 -2477 4 33.7458 26.9646 36.5669 26.0782 -29.6148 -21.0343 -2478 6 32.3696 8.32545 27.9988 -31.7689 14.924 14.5852 -2479 4 32.5206 9.30939 28.0669 10.5891 -30.1429 -9.37737 -2480 4 33.1235 7.86931 27.6333 20.3768 10.5357 -6.59273 -2481 6 11.7881 0.276326 26.9686 -1.26514 -24.1343 -2.09554 -2482 4 11.7898 41.2288 26.6922 -1.19404 21.3361 9.01519 -2483 4 11.5977 0.31005 27.9205 2.09711 -1.6438 -10.9729 -2484 6 1.68282 0.256654 10.3371 7.78574 -7.1909 -12.7427 -2485 4 1.59984 41.2742 10.69 -0.913761 -2.35777 -0.20094 -2486 4 1.41183 0.821253 11.0453 -5.61238 10.3042 16.839 -2487 6 6.75659 13.8554 8.24275 2.15336 8.75665 -12.4729 -2488 4 6.4538 13.9004 7.29654 11.603 6.79512 25.9161 -2489 4 7.29723 14.6482 8.44053 -3.39366 -6.31817 -8.96948 -2490 6 22.229 20.5516 6.16712 -19.4021 -6.23502 11.2792 -2491 4 21.7175 21.3783 6.29668 6.22315 -10.0472 -0.391558 -2492 4 21.7004 19.8262 6.58709 9.33903 15.1246 -7.94106 -2493 6 17.3809 20.4508 10.8712 -6.33142 3.08518 -4.04876 -2494 4 16.5461 20.08 10.4568 21.8919 23.129 5.85777 -2495 4 17.5363 21.4129 10.6625 -13.97 -26.3983 1.7074 -2496 6 17.7006 4.52466 19.5892 5.66371 -4.97651 -9.86024 -2497 4 16.9376 4.52739 20.1892 -4.06273 -5.34645 -7.80596 -2498 4 17.5412 3.84457 18.8839 -0.885651 16.9891 23.3258 -2499 6 0.475545 18.1168 40.0844 5.30586 -7.45209 -16.0452 -2500 4 0.255658 18.7395 40.7612 -0.602959 14.3131 10.4938 -2501 4 1.33302 18.3868 39.7002 -7.70736 -6.31105 3.74686 -2502 6 22.9439 24.8338 27.8349 -3.23408 23.09 -51.7359 -2503 4 22.7283 25.5292 27.1178 5.97449 -27.0764 31.3639 -2504 4 22.8278 25.2464 28.677 -4.11703 14.8593 21.0934 -2505 6 42.7959 39.1553 26.7627 -13.6288 14.9904 24.3142 -2506 4 42.9559 38.4383 26.1586 10.7263 -7.78522 -15.113 -2507 4 43.351 39.9224 26.5692 3.77188 -7.24305 -5.18193 -2508 6 26.2354 3.05796 21.7982 1.74018 25.1467 -10.7915 -2509 4 25.6923 3.78105 22.1642 10.9011 -13.8467 -3.1836 -2510 4 26.7888 3.50003 21.1142 -10.0122 -11.5362 10.4851 -2511 6 54.6007 9.88011 29.5829 2.61324 -0.835643 16.9334 -2512 4 53.983 9.1383 29.6239 1.49377 0.577448 -2.59463 -2513 4 54.746 10.0983 30.5296 -2.21833 -1.79811 -18.9561 -2514 6 24.7578 33.7363 20.5387 -17.5006 5.04967 -0.0763559 -2515 4 24.6934 34.6555 20.8512 7.60819 -4.12262 3.6003 -2516 4 23.9235 33.6132 20.0554 5.3121 -3.42637 -1.44671 -2517 6 41.6963 16.3109 0.897802 2.88421 10.066 -28.0255 -2518 4 41.3077 16.0362 1.70176 -16.3219 -5.78099 30.2108 -2519 4 42.6299 16.1901 1.06805 12.6035 -3.11322 -2.97519 -2520 6 23.404 27.9303 27.4821 -1.06023 20.2241 -21.3645 -2521 4 22.8141 28.2554 28.1835 2.551 -1.87769 -8.73241 -2522 4 23.2629 28.4828 26.6516 2.17993 -16.4871 31.3925 -2523 6 32.7813 37.2936 18.7328 38.5641 -14.7697 6.75932 -2524 4 33.752 37.1016 18.9061 -34.9795 -0.437252 0.892363 -2525 4 32.8311 38.1729 18.3762 -6.70298 14.6722 -8.07554 -2526 6 21.2305 27.6771 4.7955 -18.4608 -25.795 -24.9287 -2527 4 20.5062 27.4644 5.39651 2.92048 5.31567 1.45057 -2528 4 20.941 27.2184 3.94502 12.5509 18.4099 23.8236 -2529 6 54.9409 17.9571 1.83459 -7.07205 6.42915 6.55936 -2530 4 54.7029 17.1381 1.42965 7.06691 -21.815 -7.49321 -2531 4 54.119 18.4405 1.74821 -9.38537 8.8513 -0.363257 -2532 6 36.7335 10.6984 6.58912 -34.5362 -0.324761 -4.53473 -2533 4 35.7609 10.9799 6.6143 34.1258 -12.1011 2.72213 -2534 4 36.7696 9.77633 6.90859 -3.13742 6.31851 -1.30765 -2535 6 54.2706 4.50024 14.0257 -11.269 5.99606 -15.4247 -2536 4 53.8536 5.11876 13.3604 4.87759 -11.992 26.1673 -2537 4 53.895 4.59469 14.9192 -3.76531 8.72829 -7.53187 -2538 6 22.107 12.8255 32.0148 27.0088 -6.82073 4.3703 -2539 4 21.2061 13.1328 31.8952 -10.7145 6.62508 -9.34344 -2540 4 22.7298 13.2576 31.3917 -17.4011 -3.99159 8.00208 -2541 6 15.2931 36.6619 4.04206 -24.4039 12.3238 20.1693 -2542 4 15.3606 37.6342 3.9855 6.08423 -9.62309 -2.22716 -2543 4 16.0243 36.2999 3.55051 12.1414 -1.28609 -8.9598 -2544 6 23.9518 1.27347 5.70825 1.82336 16.8815 15.3992 -2545 4 23.158 0.731739 5.71694 -5.31944 -7.03749 -3.2154 -2546 4 23.9846 1.73289 6.57368 -1.26671 -8.46254 -14.2674 -2547 6 14.3069 12.6571 15.8074 -11.3886 -13.8779 -22.9988 -2548 4 14.4908 12.4438 14.8835 17.1875 4.58775 1.43504 -2549 4 13.3991 12.3171 15.8566 5.60683 8.95198 18.2444 -2550 6 15.0463 40.2277 6.58272 -14.4539 15.1029 5.15073 -2551 4 15.8086 40.489 7.08192 22.3652 -6.01515 7.9389 -2552 4 14.4962 41.022 6.75392 -6.77819 -16.9793 -13.6053 -2553 6 48.5629 32.6194 12.091 2.37027 -5.84764 -3.4739 -2554 4 48.1048 31.8776 11.6348 7.57669 12.4587 1.43975 -2555 4 49.3373 32.9111 11.5511 -18.0393 -12.2542 5.39731 -2556 6 11.2883 31.5349 7.21941 -5.75599 -10.1169 -16.3625 -2557 4 10.675 30.8987 6.79271 12.7122 10.5617 8.56414 -2558 4 11.681 32.0415 6.48473 -4.52974 -6.63428 7.17241 -2559 6 30.1204 27.9925 10.216 2.65146 5.67665 0.571004 -2560 4 30.7332 28.7325 10.019 -7.63861 -11.6097 -0.594568 -2561 4 29.9063 27.5181 9.39417 2.857 4.22172 -1.33476 -2562 6 27.6817 22.1076 17.3717 2.13561 -8.21554 7.46684 -2563 4 27.3138 21.4721 16.7296 5.88092 9.15558 -3.1228 -2564 4 28.0594 22.8778 16.9197 -3.27829 -5.84867 -5.86393 -2565 6 12.9588 4.5965 18.1625 2.45174 -26.8216 -12.137 -2566 4 13.4346 3.75914 18.3684 -5.38503 16.4797 0.486183 -2567 4 12.5704 4.4145 17.2814 1.35975 11.1796 8.84538 -2568 6 19.7171 6.72206 19.0824 18.7149 18.1076 8.78634 -2569 4 19.0276 6.07043 19.1643 -12.8479 -14.7766 2.48779 -2570 4 20.149 6.78349 19.9504 -8.03044 -1.70313 -8.42964 -2571 6 37.158 31.386 11.4948 13.5333 -6.17925 -0.534196 -2572 4 36.3748 31.5241 12.0574 10.6691 -10.2998 8.4252 -2573 4 37.8298 30.7884 11.9154 -26.2348 9.80485 0.777976 -2574 6 3.12167 16.2038 27.3537 -19.2499 -26.3416 -14.9115 -2575 4 2.564 15.4232 27.613 17.9651 21.4634 -3.17821 -2576 4 3.05771 16.2343 26.3741 -0.0558506 5.44355 20.7735 -2577 6 15.7152 9.97508 38.3617 37.2659 20.4939 22.6587 -2578 4 16.1689 10.8384 38.1525 -17.0523 -25.976 5.55091 -2579 4 16.2475 9.64647 39.1327 -18.0975 2.21635 -20.7757 -2580 6 13.3945 14.2914 8.22355 52.7406 24.0557 20.8129 -2581 4 13.9343 15.0997 8.53617 -32.8018 -27.7376 -11.9171 -2582 4 14.0669 13.5802 8.35008 -24.0553 1.67412 -6.96019 -2583 6 1.72299 24.3133 36.3936 32.5837 -28.3335 21.1288 -2584 4 1.96116 25.1215 36.8464 -1.44419 12.4956 -1.11134 -2585 4 1.10799 24.5417 35.7277 -24.491 15.1488 -24.3141 -2586 6 11.1925 26.5189 32.9725 1.88857 3.23229 20.5962 -2587 4 10.9062 26.8258 32.1286 -6.138 -2.28585 -27.1412 -2588 4 11.0637 27.2989 33.5293 3.02186 -7.15206 7.83107 -2589 6 29.5898 0.769141 36.29 0.770047 10.6645 18.3277 -2590 4 29.1085 0.54227 35.5145 -3.81283 -13.529 -27.0487 -2591 4 28.8904 1.11515 36.8518 6.86702 4.29265 4.12775 -2592 6 43.6054 13.1224 23.9122 -2.46968 6.93561 -17.1322 -2593 4 42.8447 13.3401 24.4619 -4.47847 1.10283 0.728731 -2594 4 43.3126 13.2067 22.9653 4.50753 -0.208477 27.3689 -2595 6 7.45217 19.7807 19.6677 5.33955 -1.6221 -12.877 -2596 4 6.80427 19.1226 19.9251 -3.45906 -4.13396 8.35684 -2597 4 7.46466 19.745 18.7046 0.226191 5.91599 3.73904 -2598 6 24.4186 4.28854 7.83154 -9.27237 -3.93777 -5.86373 -2599 4 24.1141 5.19611 7.95791 2.72117 -5.11917 -0.666563 -2600 4 25.0574 4.07609 8.5187 1.73531 2.38301 -0.0162684 -2601 6 51.4783 30.2365 31.1578 4.43663 8.1051 17.8753 -2602 4 50.5719 29.9409 31.3316 -1.01079 -0.531629 -9.26743 -2603 4 51.6665 30.2531 30.2149 -6.58635 -1.64064 -12.0931 -2604 6 0.928618 23.6677 16.8891 39.1558 -2.20072 16.2176 -2605 4 0.0728448 23.4362 16.5368 -6.93512 -13.3273 -6.91209 -2606 4 1.45563 22.867 17.1505 -20.9828 13.2836 -9.64814 -2607 6 45.0876 19.3948 15.692 7.86589 27.8079 -34.4593 -2608 4 45.9117 18.9264 15.546 6.38244 -8.87865 2.87525 -2609 4 44.6429 18.9609 16.3882 -19.7965 -22.2098 30.8606 -2610 6 17.4975 8.71947 40.5884 -15.3884 33.6574 -8.04213 -2611 4 18.1832 9.38307 40.741 -0.0730079 1.31818 -0.306908 -2612 4 17.9142 7.90906 40.8182 15.4372 -26.466 6.58932 -2613 6 30.1853 27.2566 27.195 -12.9952 17.3445 1.1523 -2614 4 31.1231 27.467 27.0889 -0.851996 0.391463 0.93648 -2615 4 29.6983 28.1205 27.2412 18.1484 -22.709 -4.59112 -2616 6 43.0643 26.2027 28.3545 -5.31946 22.0639 -20.7107 -2617 4 43.281 25.753 27.5201 1.76973 -3.45008 6.18356 -2618 4 43.0898 25.5645 29.0616 2.35339 -12.574 6.70826 -2619 6 27.9963 7.58777 3.05558 10.5798 9.34284 19.8534 -2620 4 28.0446 6.83168 2.47717 -2.58104 -14.3156 -10.0889 -2621 4 28.509 7.35692 3.86128 -6.64638 2.01122 -8.68086 -2622 6 44.6822 7.22369 10.1895 -15.4824 21.4485 13.7445 -2623 4 44.4465 7.45383 11.1264 7.27839 -9.51736 -18.1425 -2624 4 45.2115 6.42757 10.2073 4.94307 -7.89984 8.76143 -2625 6 23.5336 20.3897 32.2571 -4.86538 -1.36788 -16.1605 -2626 4 23.3032 21.2113 32.7104 1.28111 0.523216 5.34569 -2627 4 23.9774 19.8232 32.8948 2.81274 0.218846 6.19737 -2628 6 37.5478 21.0473 29.278 -18.5062 7.79735 6.57819 -2629 4 37.2371 20.358 28.6908 4.72073 -14.165 -12.1471 -2630 4 36.7158 21.4163 29.628 13.2175 4.90017 2.66375 -2631 6 49.286 29.0703 28.699 10.8186 8.22027 -9.31733 -2632 4 48.7028 29.7991 28.456 -10.3299 -0.414367 -0.610456 -2633 4 50.1517 29.4276 28.433 0.637469 -9.81751 4.99071 -2634 6 47.52 18.1671 15.2208 -2.7229 30.7912 -34.1138 -2635 4 48.0078 17.7317 15.8928 12.2019 -13.0526 25.5862 -2636 4 48.0044 19.0008 15.0204 -10.6208 -16.322 3.06818 -2637 6 23.2448 11.1727 16.5931 -14.8157 -11.6244 -0.308602 -2638 4 23.8342 11.8286 16.2582 11.4387 21.3683 -6.30591 -2639 4 23.6559 10.3501 16.3116 -3.14365 -5.23997 2.15847 -2640 6 3.13911 8.33446 23.1963 -2.69702 8.14317 3.16076 -2641 4 3.4034 7.82956 22.4196 3.11719 -1.75335 -2.44085 -2642 4 3.61355 9.18537 23.1574 -2.855 -3.87959 1.25156 -2643 6 0.502965 16.1866 6.18545 3.06312 3.24934 37.7622 -2644 4 1.47856 16.2897 6.04903 -24.0003 -4.70784 4.68468 -2645 4 0.309706 16.1237 7.18858 13.4295 2.89967 -42.1744 -2646 6 43.1771 15.7066 5.83749 -5.07319 -7.51407 -5.60477 -2647 4 43.0136 16.4204 6.43488 -7.5966 11.2789 14.4199 -2648 4 44.0623 15.8898 5.5251 15.5631 0.134699 -7.60204 -2649 6 16.7019 35.4798 34.4572 -11.2013 7.16284 28.6023 -2650 4 15.9782 34.9492 34.0738 5.35466 1.61493 8.45244 -2651 4 16.3895 35.7941 35.362 6.52255 -9.83405 -29.4813 -2652 6 38.8822 7.74245 15.6771 24.467 26.2162 11.5837 -2653 4 39.1941 7.06316 15.0707 0.325231 -3.95447 -5.25413 -2654 4 39.6937 8.2709 15.9758 -30.2905 -22.5291 -12.0432 -2655 6 42.0043 36.5204 13.6369 3.57579 19.2035 0.0265624 -2656 4 41.9371 35.5667 13.6578 -6.58441 -9.91584 1.38486 -2657 4 41.1548 36.8737 13.3269 0.670997 -7.61264 0.497391 -2658 6 54.2965 15.3698 32.1203 7.94984 -1.57724 11.6593 -2659 4 0.00278476 15.9714 32.4364 -1.97539 -6.90512 -0.0853595 -2660 4 53.6257 15.9484 31.7567 -4.83125 0.736868 -4.95397 -2661 6 22.8953 13.994 39.0277 29.317 0.766946 3.70607 -2662 4 23.2673 14.8115 39.3939 -3.87119 -6.48985 -1.20924 -2663 4 21.9724 14.1463 38.894 -27.0425 2.87882 -4.26486 -2664 6 48.0413 28.5291 4.79053 -11.6037 -2.58599 22.6989 -2665 4 48.6027 28.7991 4.07655 16.555 3.34212 -19.6439 -2666 4 47.7045 29.3636 5.15455 0.064426 -0.719185 3.47056 -2667 6 48.8324 10.6079 2.66689 -4.06073 -3.45613 -38.269 -2668 4 48.225 10.1372 3.21562 -13.339 -11.2438 14.6703 -2669 4 49.3888 11.1314 3.20945 16.7197 17.33 23.918 -2670 6 17.1017 29.3417 4.42129 -6.1746 1.2215 19.6287 -2671 4 16.2515 28.9749 4.73431 4.06151 0.983408 -5.41825 -2672 4 17.5169 29.7258 5.22535 1.37581 -6.66399 -13.2687 -2673 6 27.7925 7.31966 26.5665 39.3465 35.5797 -5.30427 -2674 4 28.7629 7.09708 26.703 -34.5848 -6.71948 -0.628584 -2675 4 27.2286 6.57009 26.6643 -1.86949 -31.2701 4.24572 -2676 6 18.0221 22.0409 22.5172 -16.5701 10.2349 -21.3339 -2677 4 18.5639 21.2383 22.5163 -1.8186 -3.43948 -8.36361 -2678 4 17.5144 22.1102 21.6408 22.068 -10.0871 32.2991 -2679 6 22.1395 25.0891 16.7042 -20.9036 23.9116 7.05274 -2680 4 21.7854 25.6501 15.9625 11.5166 -19.4533 18.3362 -2681 4 22.5191 24.3092 16.3181 5.92374 -8.20656 -11.3677 -2682 6 25.488 28.4523 7.12785 -10.8823 -15.9396 20.8595 -2683 4 25.4981 28.5494 8.12476 3.48758 8.16016 -33.1398 -2684 4 25.5521 29.3092 6.69674 -1.4246 11.8198 7.49476 -2685 6 42.5416 24.7341 23.7389 -17.4504 20.5814 2.46415 -2686 4 41.7374 25.1978 24.1118 21.637 -12.0739 -8.95046 -2687 4 42.3838 23.7928 23.8344 -7.43983 -12.597 1.84916 -2688 6 6.22002 16.6178 2.47863 15.1987 22.5956 5.3052 -2689 4 5.33799 17.0017 2.41879 -13.1624 -14.3434 -0.0608379 -2690 4 6.24934 15.6649 2.55192 -10.5885 -12.312 -0.729605 -2691 6 47.3735 33.281 1.45237 -1.26376 -9.34891 -34.4477 -2692 4 47.004 34.1558 1.53803 -0.151384 8.42018 6.19826 -2693 4 47.7374 33.0316 2.29181 5.29029 2.56444 17.845 -2694 6 1.28124 36.1882 24.8833 15.6174 10.404 -23.7919 -2695 4 0.591937 36.4933 25.4703 -7.67557 -4.15788 11.0948 -2696 4 1.63511 35.375 25.2549 -3.92235 -3.89482 10.8998 -2697 6 20.9296 29.0485 16.4244 -14.8946 8.72798 0.140185 -2698 4 21.4494 28.4837 15.8729 6.14594 -21.5718 -11.6475 -2699 4 21.5122 29.7657 16.643 5.64358 11.2813 6.66084 -2700 6 18.6504 32.5428 14.1464 30.5599 1.70581 -2.73789 -2701 4 17.8579 33.056 14.2705 -20.3424 -4.20043 8.80032 -2702 4 18.5989 31.5954 14.3835 -16.0449 10.8642 1.76069 -2703 6 15.729 41.6925 0.00385817 -5.28292 -15.868 -0.0471225 -2704 4 15.6317 41.084 41.1283 -1.722 11.921 23.9575 -2705 4 15.1873 41.3899 0.782005 8.67232 1.52126 -23.9336 -2706 6 20.5292 18.4098 7.21323 -2.91221 4.89049 5.17577 -2707 4 20.2914 18.5583 8.16487 -5.028 -0.721877 -18.2737 -2708 4 19.7413 18.3526 6.62958 8.30767 0.291632 18.8261 -2709 6 35.3342 2.82915 1.61883 3.51298 26.3767 19.1091 -2710 4 35.0331 3.19583 2.50754 16.3791 -7.36031 -35.2043 -2711 4 35.9206 3.53855 1.22039 -16.4006 -18.5858 14.5973 -2712 6 48.9922 19.6721 24.94 -34.075 0.0390245 -1.22883 -2713 4 49.8199 19.2352 24.7823 16.5976 -0.114011 -0.96393 -2714 4 49.1617 20.6125 25.0649 5.94448 -3.86752 4.03728 -2715 6 26.0294 7.18427 41.5679 18.6543 -22.0446 -14.9111 -2716 4 26.7755 6.56315 41.735 -11.6555 11.6244 -4.08136 -2717 4 25.6575 7.3193 0.515359 -11.3234 5.2253 22.1616 -2718 6 22.0232 3.61039 29.0191 -5.74486 -2.38085 -7.46091 -2719 4 21.2539 3.82496 28.4513 11.98 3.27859 6.66273 -2720 4 22.2148 4.35673 29.5966 -4.60401 3.08527 0.791206 -2721 6 27.8512 32.5337 20.6565 16.709 -10.0789 14.6393 -2722 4 26.9625 32.7469 20.4552 -34.4793 1.21347 -3.16249 -2723 4 28.3469 33.1233 20.1026 12.1012 5.18966 -5.24336 -2724 6 8.41229 24.7869 3.46082 22.3386 15.1563 9.53263 -2725 4 8.90357 24.2552 2.84068 9.55631 -8.44952 -10.853 -2726 4 7.60423 24.3318 3.61908 -22.8615 -12.1417 2.22131 -2727 6 30.5897 41.7312 15.6484 22.6974 7.2585 28.5546 -2728 4 29.9644 0.0840213 16.3484 1.9076 -3.76769 -8.41354 -2729 4 30.1014 41.5664 14.8669 -20.7398 -7.21626 -25.2002 -2730 6 48.088 5.62638 21.1953 6.60529 -8.20232 0.106871 -2731 4 47.6746 6.34733 20.7055 -8.23977 -5.05625 1.96425 -2732 4 47.4017 5.06013 21.5879 -0.150274 10.975 -6.21391 -2733 6 39.4216 23.1741 35.7526 -24.6601 -13.9913 -21.1364 -2734 4 39.9113 23.6202 36.3986 28.8985 24.9348 33.8823 -2735 4 38.8958 22.5444 36.2533 -4.57276 -5.65639 2.90172 -2736 6 51.5794 33.3637 5.78804 -15.2387 -43.0642 -16.4958 -2737 4 51.7543 34.264 5.94613 8.32006 43.2545 8.99501 -2738 4 51.5314 33.243 4.82206 1.27667 3.09716 8.04215 -2739 6 40.1245 17.6149 30.7901 8.56984 -3.86721 -1.09973 -2740 4 39.7659 18.4612 31.0527 -2.58034 0.199434 5.42908 -2741 4 40.7245 17.8709 30.0792 -0.880063 -10.8459 -3.09375 -2742 6 46.409 9.80599 18.5787 -10.6525 10.5445 16.3312 -2743 4 47.1858 10.3579 18.4839 1.73901 1.20814 1.97642 -2744 4 46.4156 9.2339 17.8265 -1.18405 -17.3223 -19.0152 -2745 6 15.8964 41.084 31.9275 -7.67529 -16.3413 6.36199 -2746 4 16.5726 40.6297 31.3851 0.744388 15.1086 2.48527 -2747 4 16.0838 0.121849 31.9545 10.6182 0.477469 -6.79561 -2748 6 48.5579 25.7373 14.9245 -32.9201 0.62376 14.4593 -2749 4 49.4842 25.8337 14.7718 19.5896 2.21134 -17.0603 -2750 4 48.049 25.8802 14.1037 15.4245 2.93063 1.46628 -2751 6 39.2312 28.9787 36.1455 -14.672 -4.00104 3.01304 -2752 4 39.9934 29.3216 36.628 6.25522 6.25199 -7.03146 -2753 4 39.4638 28.7366 35.2366 10.4577 0.0924929 -3.6403 -2754 6 37.3289 21.0516 14.9314 -10.8689 -7.09111 1.49701 -2755 4 38.071 20.892 14.3011 -28.0288 10.0477 -1.14031 -2756 4 36.4673 21.3942 14.5393 36.2132 -8.93414 7.14583 -2757 6 32.4934 22.8531 15.7417 3.10645 -11.4389 20.7178 -2758 4 31.7266 22.539 15.2235 4.17967 -1.79737 6.20971 -2759 4 32.6084 22.2825 16.5528 -7.19864 12.5613 -26.7488 -2760 6 18.5678 8.15053 37.5885 12.1963 17.253 1.38788 -2761 4 19.2402 8.85275 37.7813 -15.6951 -12.294 2.78452 -2762 4 17.9606 8.11124 38.3342 2.60008 5.05619 4.87993 -2763 6 46.9436 30.3797 11.0104 1.88703 -1.83756 -2.66296 -2764 4 46.4577 30.6986 10.2121 16.8565 -15.5671 12.8865 -2765 4 47.4104 29.5424 10.7815 -11.8828 15.01 -3.66074 -2766 6 54.6316 13.0448 30.6676 -4.47091 -6.8042 2.85617 -2767 4 54.8929 12.2323 31.1402 -1.2342 7.60269 0.15722 -2768 4 54.6603 13.771 31.309 -0.297949 0.849652 -1.52079 -2769 6 32.2951 35.1224 27.9786 -1.77947 21.9995 15.3623 -2770 4 32.2792 35.8643 28.662 -2.01418 -27.5067 -15.3374 -2771 4 32.1621 34.2527 28.3767 0.559318 -0.0892981 14.8897 -2772 6 4.45055 25.4036 31.7899 -1.02142 -16.2715 16.4968 -2773 4 4.99753 24.9958 32.4777 -6.33224 -6.47315 3.67169 -2774 4 4.91071 26.2154 31.6821 9.55032 31.2277 -12.9728 -2775 6 40.7771 38.1434 21.8579 6.80518 1.6634 -4.63259 -2776 4 40.7449 39.0581 22.1203 -10.5616 15.8809 15.9679 -2777 4 41.4448 38.2055 21.1733 6.63637 -13.627 -11.1518 -2778 6 26.6799 9.85647 27.3982 -25.6987 30.8747 18.2417 -2779 4 27.0738 9.12687 26.9584 7.64189 -30.2216 -11.3166 -2780 4 25.7862 9.62595 27.7363 13.5029 -2.01996 -6.34848 -2781 6 53.4177 39.431 11.7682 60.4327 6.90374 -14.3662 -2782 4 54.4363 39.4906 11.5459 -51.7213 -2.15349 13.0324 -2783 4 53.0514 40.2823 11.4531 3.65586 -10.6921 6.91198 -2784 6 35.3318 21.4177 2.24537 5.41769 -12.1321 -20.1082 -2785 4 34.8431 20.6225 2.51379 1.47903 7.83344 1.83382 -2786 4 35.7036 21.1864 1.3528 -11.9529 6.47568 24.5243 -2787 6 4.13637 17.136 33.9211 3.37621 -12.3766 5.67686 -2788 4 4.20441 16.396 34.5697 -7.88327 11.3141 -11.775 -2789 4 3.23668 17.1493 33.5445 4.32036 -6.23827 5.33579 -2790 6 24.1551 16.173 14.6595 0.905264 -13.203 -15.7913 -2791 4 24.2344 17.0724 14.9677 3.21898 8.1818 3.14137 -2792 4 23.7074 16.2777 13.8038 1.81958 -4.41422 2.08172 -2793 6 43.135 2.84466 26.1032 13.1229 6.35408 -5.68313 -2794 4 42.2875 3.17639 26.414 -4.49653 4.08553 -4.30298 -2795 4 43.2684 3.17059 25.1875 -5.24638 -3.17663 12.7173 -2796 6 40.6938 12.184 1.56501 -11.5288 -7.07153 -25.6549 -2797 4 41.6237 12.1687 1.8186 -0.151998 5.09311 17.9246 -2798 4 40.0653 12.4844 2.24465 11.7671 0.703669 4.7582 -2799 6 47.3771 8.09383 26.755 61.1653 27.2124 16.0462 -2800 4 46.6352 7.69428 26.3774 -33.8593 -24.2939 -29.8281 -2801 4 48.1554 8.02079 26.1437 -24.5213 -4.41693 14.2109 -2802 6 35.8722 30.7298 38.4929 46.7797 8.20249 -0.795626 -2803 4 35.8437 29.9971 39.0885 -23.8052 -20.0767 8.1402 -2804 4 36.8495 30.8926 38.5637 -31.083 11.8011 -18.5205 -2805 6 51.2951 23.2205 32.4921 -21.4102 17.5258 -2.96787 -2806 4 51.6315 24.0445 32.1105 -0.705735 5.94923 -0.836877 -2807 4 52.0737 22.714 32.6486 16.7198 -16.4886 4.04233 -2808 6 30.6141 4.4461 39.6711 -15.3731 3.79473 -35.0115 -2809 4 30.9464 3.61986 40.0176 9.77962 -4.83986 19.2734 -2810 4 30.7704 5.18568 40.2576 9.11216 5.26318 14.244 -2811 6 35.2646 29.7051 2.85778 -14.8887 -12.395 -20.7058 -2812 4 35.7986 29.7272 2.02588 -11.2321 -1.99949 14.2373 -2813 4 34.4405 29.1492 2.64359 32.9241 21.0754 6.44042 -2814 6 50.3111 26.1454 9.40098 -22.1621 10.9454 -20.0185 -2815 4 49.986 26.7793 8.71172 15.2241 -16.6208 13.1315 -2816 4 49.7063 25.388 9.31525 11.793 4.08785 3.97386 -2817 6 50.0869 36.8245 26.4088 -20.9012 -6.38176 7.71076 -2818 4 49.5586 36.0705 26.7514 3.9746 5.79943 -8.74909 -2819 4 50.1941 37.3864 27.1871 4.41306 8.36789 0.548966 -2820 6 40.3119 23.9565 38.5384 47.4279 -1.39254 -15.5521 -2821 4 40.88 24.732 38.748 -21.3925 -13.0784 -2.40019 -2822 4 39.4343 24.1145 38.8527 -20.1214 13.5622 11.7594 -2823 6 24.9444 10.7496 30.6663 31.051 18.5451 27.0394 -2824 4 25.7305 10.8456 31.2787 -28.4 -7.1047 -26.2292 -2825 4 24.8995 11.6269 30.2371 -7.15612 -14.1049 -2.61146 -2826 6 5.89131 1.01728 5.39947 -5.16247 -17.9253 -0.227043 -2827 4 5.22088 0.340863 5.59281 2.49468 7.88844 1.50452 -2828 4 6.71299 0.544267 5.57411 4.99832 4.76302 -4.28882 -2829 6 44.2927 29.3807 26.2764 43.728 -18.4205 -0.18667 -2830 4 43.5018 29.5461 25.816 -39.4067 7.83222 -12.62 -2831 4 44.7851 28.7616 25.699 -3.50466 6.32584 16.51 -2832 6 25.3064 10.1814 6.6654 -6.94402 -15.718 -9.61204 -2833 4 25.6542 11.0594 6.61048 6.10034 18.8978 1.37462 -2834 4 25.5624 9.77067 5.8255 0.943829 -2.29537 1.40094 -2835 6 13.3606 28.0664 2.58456 21.0736 -2.27515 1.79417 -2836 4 12.4645 27.8304 2.42125 -25.9451 -0.745297 2.44011 -2837 4 13.7867 27.7237 1.79619 10.8353 3.06046 3.23802 -2838 6 6.45257 40.24 18.0133 20.0379 8.33657 1.98834 -2839 4 6.89988 39.3931 17.8777 -5.14522 -3.62214 0.392952 -2840 4 5.56311 40.1207 17.6969 -15.0406 -3.82351 -6.06839 -2841 6 47.8011 13.5056 2.01844 -10.5648 -21.267 23.3214 -2842 4 48.1524 12.6081 2.17165 -2.87721 6.43796 -2.24674 -2843 4 48.4275 13.9546 1.48105 20.9852 11.6376 -18.273 -2844 6 13.5939 20.3067 2.43603 17.8956 14.689 14.157 -2845 4 13.8339 19.6256 3.09172 -4.40777 3.66463 -6.9739 -2846 4 12.9598 19.9059 1.86118 -14.8369 -10.3601 -11.305 -2847 6 15.2334 0.8368 36.6591 1.55142 7.70692 -22.3998 -2848 4 15.2542 1.38367 37.4773 0.960764 -3.32816 -20.1037 -2849 4 15.3344 1.45306 35.8608 -4.23652 -17.7771 37.8382 -2850 6 33.6147 35.2459 15.1 16.7734 -11.8793 -18.4599 -2851 4 33.8163 35.2873 16.0538 13.2499 -3.34836 -12.9991 -2852 4 34.4154 34.9808 14.5294 -23.6504 9.8312 34.8639 -2853 6 21.8005 9.23588 0.431159 13.8262 -19.7524 30.0596 -2854 4 22.4067 9.05801 41.6249 5.27322 -0.932182 -12.5411 -2855 4 21.1072 9.74412 0.0564903 -22.836 18.1195 -16.0408 -2856 6 38.1565 27.4627 3.04439 18.4183 -28.2807 7.84104 -2857 4 37.7322 27.3164 2.21113 -4.60599 -14.2952 -24.3043 -2858 4 37.7632 28.2451 3.34335 -13.6136 36.2365 19.5187 -2859 6 38.8873 27.196 11.7739 15.5044 -8.33717 -5.93911 -2860 4 38.7841 26.3327 12.232 6.37868 6.61944 -11.5261 -2861 4 39.5786 27.1133 11.0659 -17.5863 -8.28826 19.2684 -2862 6 29.8757 41.5959 28.7066 13.5858 28.49 -11.3766 -2863 4 28.9647 41.3014 28.7466 -9.40406 -2.02578 1.88502 -2864 4 29.8997 0.254331 27.9025 -2.68961 -11.7418 13.302 -2865 6 34.0266 8.72323 38.0698 33.719 9.40995 4.6971 -2866 4 34.8877 8.24089 38.094 -11.378 13.1352 -1.62724 -2867 4 33.3712 8.08689 37.8245 -20.4874 -15.945 -8.86187 -2868 6 38.8142 27.3472 30.6886 -7.48306 -22.0573 -0.58069 -2869 4 38.4096 26.5151 30.3537 9.19692 16.3236 1.53567 -2870 4 38.2655 27.5885 31.4334 -4.0026 6.56393 5.14207 -2871 6 41.6513 17.2644 36.3568 8.49285 18.5772 4.12306 -2872 4 41.236 17.1887 35.5016 -7.55839 -3.54967 -10.3568 -2873 4 41.7813 16.3888 36.7033 1.22956 -17.0266 1.65102 -2874 6 30.7157 26.9788 35.2038 -10.151 -4.28381 0.0670681 -2875 4 31.4488 27.4236 34.7965 20.0965 0.384289 -13.2747 -2876 4 30.343 27.6484 35.7639 -8.80839 6.96039 12.3672 -2877 6 47.5342 4.10778 27.2888 11.6095 8.93875 26.3727 -2878 4 46.6105 4.27591 27.501 -8.38331 -0.425724 -4.8003 -2879 4 47.5988 3.99389 26.3497 -6.2541 -0.220522 -17.1995 -2880 6 20.9412 8.38521 7.26575 -18.1268 -17.2637 2.68033 -2881 4 20.8809 8.87169 8.08328 -6.592 1.96128 21.9757 -2882 4 21.4179 8.98778 6.73029 19.5174 18.1449 -30.7672 -2883 6 36.8608 13.6781 0.872276 -22.567 18.0135 -7.8322 -2884 4 37.3857 13.5342 1.64823 18.2236 -14.2068 17.6988 -2885 4 36.9649 12.9376 0.269125 7.56106 -9.0363 2.17502 -2886 6 28.5805 20.3012 26.4498 13.4935 0.222411 -13.7489 -2887 4 28.4835 19.3803 26.2016 0.90122 -3.21423 2.30104 -2888 4 27.7964 20.5416 26.9224 -18.5183 5.12398 12.3317 -2889 6 51.6021 16.8515 33.5179 -11.2544 -15.3 0.627003 -2890 4 51.563 16.0241 34.0301 0.916298 4.09207 -0.753195 -2891 4 51.0058 16.6639 32.7753 6.31462 4.20327 -0.345536 -2892 6 16.2626 32.019 37.6812 -31.2107 -29.2496 -22.9287 -2893 4 16.4537 31.3803 38.4011 -2.23747 12.829 -12.3594 -2894 4 15.5373 31.5705 37.1079 31.9743 21.1891 23.5065 -2895 6 14.3366 25.8859 13.2055 -16.2598 35.1345 -7.65407 -2896 4 13.5591 26.1022 13.7538 4.79106 -9.45955 4.66587 -2897 4 14.3924 26.7004 12.6499 8.67511 -16.0651 4.90492 -2898 6 54.9632 28.863 3.30225 1.80665 -46.0259 4.02989 -2899 4 54.8334 28.8705 2.33571 2.30679 -1.29159 7.0988 -2900 4 0.250446 27.9134 3.53944 -11.9885 37.0888 -10.0107 -2901 6 17.2065 5.13222 2.58226 -24.5489 -19.7693 -14.9516 -2902 4 17.8239 4.45011 2.8785 5.4716 1.45995 5.40018 -2903 4 17.4096 5.93537 3.0482 10.2082 3.99522 6.08435 -2904 6 50.7076 33.0524 10.3335 3.48719 10.0002 9.95533 -2905 4 50.6136 33.804 9.75033 0.0726689 14.8217 2.89741 -2906 4 50.6632 32.3255 9.72979 -1.7797 -23.5385 -6.20373 -2907 6 28.8719 19.8379 32.3662 12.2168 9.43689 -9.94144 -2908 4 29.8293 20.0527 32.223 -26.7315 -2.75674 4.09206 -2909 4 28.3919 20.677 32.2058 6.96369 -8.55206 2.54368 -2910 6 22.4258 12.8301 23.3099 -21.9068 12.8519 23.6974 -2911 4 22.5424 12.4187 24.2055 -3.2327 9.70973 -17.8182 -2912 4 21.6904 13.4906 23.4219 18.0295 -16.5223 -3.23075 -2913 6 54.7859 15.5473 8.87871 3.42684 8.57095 -7.37477 -2914 4 0.5152 15.244 9.45304 -3.41058 -4.28924 6.32649 -2915 4 53.9742 15.1056 9.16818 6.16615 -2.4265 3.01646 -2916 6 10.455 19.2982 26.169 33.281 -8.93788 40.2277 -2917 4 11.227 18.6906 26.1605 -15.5014 12.2348 -4.03004 -2918 4 10.0694 19.2521 25.3251 -19.4777 -1.76614 -41.28 -2919 6 38.6541 20.3016 35.2246 25.1317 -2.89776 0.584273 -2920 4 39.6122 20.389 35.0245 -16.8563 1.20482 1.7302 -2921 4 38.6037 19.6498 35.9401 -3.42784 5.37932 -3.92632 -2922 6 17.4847 18.0451 15.2473 -2.11698 43.6037 15.5575 -2923 4 17.3165 17.6253 14.4157 -4.81229 -12.7227 -25.2707 -2924 4 17.3243 19.0143 15.0283 6.45297 -29.0578 8.37137 -2925 6 29.6412 0.96029 26.2538 -2.92598 -32.1867 -14.968 -2926 4 29.2295 1.80722 25.9783 -5.05853 -19.2177 -5.0061 -2927 4 29.2302 0.136786 25.7855 11.2507 47.838 14.1271 -2928 6 30.4583 12.6781 28.2933 9.80318 -11.3268 12.128 -2929 4 29.9046 13.1756 27.6811 -9.35495 -4.05719 -6.55314 -2930 4 30.1425 11.7563 28.3949 -4.92949 12.905 -7.65094 -2931 6 36.6582 22.1039 33.3564 18.5548 3.44171 -30.7077 -2932 4 37.613 21.8793 33.4826 -21.695 5.78572 4.26475 -2933 4 36.1698 21.8632 34.1249 -2.38139 -6.6943 29.4942 -2934 6 34.851 22.4634 14.295 34.3706 -12.4795 -36.6647 -2935 4 34.1306 22.5878 14.8998 -26.9044 -0.864951 1.69223 -2936 4 34.6097 22.0485 13.4154 -10.7342 10.9778 31.0087 -2937 6 15.5278 9.60588 7.43972 42.9889 -30.8008 -13.2318 -2938 4 16.5289 9.52064 7.17624 -51.4641 3.68278 11.9177 -2939 4 15.1523 8.68078 7.51431 10.3517 24.0811 1.24627 -2940 6 21.8097 28.0449 19.8036 -9.3837 2.2861 -3.69714 -2941 4 21.8234 28.4749 20.6579 1.49564 5.45585 8.79124 -2942 4 20.892 27.7474 19.715 3.3935 -2.50466 0.747966 -2943 6 34.5377 24.4067 2.43307 17.6783 -35.0943 7.08511 -2944 4 34.5604 23.3833 2.29911 9.6022 45.0517 12.0591 -2945 4 35.2671 24.6922 3.07368 -22.5652 -15.0324 -19.8681 -2946 6 12.5974 20.9324 33.5156 -46.2472 -18.3539 -4.34371 -2947 4 11.7028 20.621 33.8238 24.9199 8.0821 6.3307 -2948 4 12.4411 20.8933 32.5604 17.1824 5.4367 5.76912 -2949 6 45.7726 31.1546 8.70236 -14.9606 25.5026 -0.599968 -2950 4 45.9029 32.1319 8.75243 4.68257 -18.3747 -3.63409 -2951 4 44.8252 31.0158 8.86685 6.58294 -2.27884 -1.49072 -2952 6 15.4856 22.546 30.183 -27.3843 -7.95278 -8.87715 -2953 4 16.2041 23.1276 30.4314 15.0704 -4.03687 4.09321 -2954 4 15.7065 21.6006 30.174 10.2057 11.8959 3.83923 -2955 6 39.7496 17.1848 38.4183 10.7213 7.86871 6.49434 -2956 4 39.4778 16.5926 37.6964 5.17631 5.73732 3.80123 -2957 4 40.5328 17.6892 38.1152 -12.3514 -12.5856 -1.70264 -2958 6 14.0114 24.6894 0.67727 2.36324 3.45559 -2.63023 -2959 4 14.2236 24.5974 1.61702 0.728832 5.12592 -0.706901 -2960 4 14.3876 25.5307 0.374588 3.08684 -2.75846 6.71077 -2961 6 31.517 19.5744 3.57234 -39.7066 16.7987 -9.47084 -2962 4 30.9812 19.3042 4.35775 22.6375 1.42354 -10.5596 -2963 4 32.4299 19.3292 3.64982 19.3858 -12.3464 7.87151 -2964 6 36.0836 25.0594 19.4567 -36.7914 6.39304 28.0525 -2965 4 37.0156 25.1955 19.4145 23.7106 3.97855 -3.98164 -2966 4 35.8434 24.7134 18.6052 0.797557 -6.28507 -17.3783 -2967 6 51.6689 17.6827 14.8094 17.1445 12.5774 26.8045 -2968 4 51.9037 18.5572 15.2299 -9.72171 -22.1194 -12.5657 -2969 4 51.1779 17.9239 14.0295 -8.26923 9.08158 -15.405 -2970 6 37.7112 27.5006 38.1887 12.9616 35.4771 9.449 -2971 4 37.6633 26.7956 37.5532 1.11487 -12.4995 -15.1422 -2972 4 38.1924 28.2458 37.7567 -11.1334 -22.4905 3.32353 -2973 6 34.7974 13.8528 30.7792 38.2139 14.8122 -13.8353 -2974 4 35.0479 14.6237 31.2931 10.1718 6.91547 -1.09557 -2975 4 34.0108 13.6012 31.1887 -47.9834 -23.6229 17.9792 -2976 6 19.6227 37.378 39.9679 -4.73731 -6.94245 -18.3615 -2977 4 20.5687 37.4692 40.1123 7.88808 5.09103 7.87528 -2978 4 19.5641 36.8976 39.1176 -6.21843 3.50671 7.67834 -2979 6 40.9479 34.0678 21.4433 -0.249567 -14.1225 -18.8789 -2980 4 41.1016 33.9428 22.3797 -2.14769 -1.67588 5.36328 -2981 4 40.6839 33.1793 21.1286 -1.36491 12.9737 -0.808456 -2982 6 32.9563 27.2052 26.5619 16.765 25.3633 38.6423 -2983 4 33.6584 27.782 27.0193 -28.2502 -21.1678 -18.3317 -2984 4 33.3196 26.985 25.7164 10.2198 -2.00428 -21.725 -2985 6 24.4119 18.6722 15.6191 2.60565 2.56356 0.790403 -2986 4 23.5591 19.1036 15.7005 -5.06369 4.62453 -0.705819 -2987 4 24.5532 18.2558 16.4735 3.02917 -4.75652 8.16225 -2988 6 29.9677 1.63803 9.07283 -8.6377 39.5876 -9.34009 -2989 4 30.0634 0.720354 9.20948 2.18912 -36.9171 5.61628 -2990 4 29.1461 1.70687 8.54641 9.48634 -0.985828 6.78106 -2991 6 31.4838 20.0989 7.86304 35.53 0.0326438 -30.7549 -2992 4 32.0429 19.6076 7.17649 -26.3889 9.76992 30.1887 -2993 4 30.8408 19.4752 8.19414 -7.49558 -12.7978 -1.24617 -2994 6 35.0504 3.77818 33.2765 0.0823497 -0.922868 12.9261 -2995 4 34.3448 4.25588 32.7981 8.7563 -3.59111 2.91721 -2996 4 34.8655 3.9194 34.2319 -2.64551 -3.11561 -17.2257 -2997 6 43.9652 7.96842 12.9746 -1.99776 -12.8019 0.966431 -2998 4 43.3695 7.30717 13.3748 13.3395 3.08022 -2.86187 -2999 4 43.3917 8.71398 12.8108 -3.39849 12.2944 -1.42541 -3000 6 44.1076 32.6848 16.9531 4.83347 14.0385 -4.8226 -3001 4 44.7886 33.3699 16.7553 -9.08835 -13.3706 7.91806 -3002 4 44.1269 32.547 17.9059 1.63547 3.97279 4.50154 -3003 6 40.604 27.1617 19.037 5.49217 0.683783 -24.0967 -3004 4 39.907 26.5243 18.7614 10.7357 10.4426 0.818988 -3005 4 41.0572 27.5561 18.2306 -16.7517 -14.1941 23.9583 -3006 6 46.0503 23.2068 29.0603 33.2935 27.7725 23.492 -3007 4 46.7239 23.8517 29.4252 -26.0483 -15.0892 -12.6312 -3008 4 46.5249 22.3737 28.9794 -1.25341 -9.22801 -2.13192 -3009 6 42.6264 30.606 18.8462 -34.271 -0.881878 -8.8004 -3010 4 43.5242 30.7893 19.1074 18.3218 -5.88078 -5.57768 -3011 4 42.5428 29.9264 18.1492 10.4183 2.57162 5.03187 -3012 6 36.1231 10.8975 23.2614 14.248 33.6052 6.96597 -3013 4 35.2264 11.248 23.1278 1.11349 -2.62395 -2.03304 -3014 4 36.6438 11.7125 23.5215 -18.5882 -27.5405 -10.5609 -3015 6 13.7387 31.5187 15.7175 -8.63655 -3.85126 -4.64142 -3016 4 14.6788 31.7096 15.8046 0.813603 4.25462 -2.48371 -3017 4 13.3439 32.0503 15.0041 7.14664 -1.81478 4.34843 -3018 6 33.1663 41.4263 27.7844 10.1514 -8.73892 50.1834 -3019 4 33.0558 0.0915148 27.0508 0.335607 20.6114 -25.4934 -3020 4 33.386 0.0476391 28.6 -4.59167 -12.6797 -24.4066 -3021 6 32.8924 22.9248 31.4777 14.8331 -14.2772 -3.0724 -3022 4 32.331 22.9976 30.6823 -4.11553 14.0534 8.76104 -3023 4 32.7731 23.648 32.1168 -12.639 5.72297 -14.9522 -3024 6 27.6514 16.8629 6.392 5.9792 -3.02818 28.7598 -3025 4 27.8554 17.3015 5.57876 -0.492343 9.99532 -20.1105 -3026 4 26.7867 16.4634 6.29535 -11.4685 -3.6273 -5.68351 -3027 6 47.2692 11.6326 26.0701 -7.51592 -12.561 -4.95541 -3028 4 47.0451 11.5188 27.0189 12.1951 16.3083 -15.426 -3029 4 47.7234 12.4489 25.7723 -5.45211 -2.19527 19.0308 -3030 6 27.5533 7.05227 7.64253 19.1893 -9.34804 28.5196 -3031 4 26.7486 7.45205 7.94122 -22.9318 8.15137 -1.85106 -3032 4 28.0959 7.04706 8.46187 -1.51515 -0.839126 -23.0353 -3033 6 39.7861 9.0687 11.9758 -15.1444 6.22431 -7.98147 -3034 4 39.495 9.25597 11.0599 4.77492 -2.72739 13.3066 -3035 4 38.9879 9.23938 12.5098 3.46881 -0.389139 -2.20355 -3036 6 18.1894 33.4728 36.1008 -27.5283 -9.1571 7.06889 -3037 4 17.6722 33.9726 35.425 4.94426 -9.47891 13.9641 -3038 4 17.5468 32.9442 36.6812 19.6546 19.0371 -24.2711 -3039 6 37.1945 26.5569 0.720807 -12.4444 8.19753 -2.53971 -3040 4 37.3568 25.6462 0.476597 4.7119 -6.04631 0.679389 -3041 4 36.2336 26.6328 0.585525 8.76389 3.8419 -0.879611 -3042 6 44.2004 19.6233 36.8917 26.7932 -13.3754 0.0595121 -3043 4 45.0387 19.0956 36.766 -19.227 18.7818 5.02367 -3044 4 44.4376 20.5683 36.9644 1.27086 -9.01627 -1.91077 -3045 6 27.7799 6.35317 35.6882 16.2858 -3.70231 1.18314 -3046 4 27.1634 6.96571 35.2926 -9.46908 3.45363 -4.90602 -3047 4 27.3042 5.53742 35.858 -2.00694 0.00942349 2.38052 -3048 6 34.7653 16.4924 20.8795 20.4023 -19.0949 10.3746 -3049 4 35.5516 15.8729 20.9898 -30.5098 25.2475 -4.70775 -3050 4 34.1298 16.2162 21.5757 7.90375 5.70636 -13.0995 -3051 6 39.0303 20.9673 40.4307 -20.4786 -67.2325 12.8224 -3052 4 38.8254 20.089 40.9106 11.5443 40.6977 -30.184 -3053 4 39.2642 21.5386 41.1412 8.11615 27.562 18.514 -3054 6 10.8068 27.9205 1.65866 27.4379 7.91142 -24.506 -3055 4 10.0967 27.7204 2.22826 -30.9372 -12.069 25.0324 -3056 4 10.8782 28.8813 1.73209 2.10338 1.16742 -2.23752 -3057 6 47.025 23.1272 13.2603 -26.8307 -11.5375 0.419605 -3058 4 47.6563 23.6094 12.7175 1.22463 1.60122 -3.88323 -3059 4 46.2701 22.846 12.6737 25.4538 5.98786 18.4886 -3060 6 34.5769 28.3999 10.6617 -26.3731 9.09486 -11.6064 -3061 4 34.5145 27.7223 11.3448 13.7244 -2.44185 1.37306 -3062 4 35.5023 28.5375 10.4336 6.33869 -4.76798 1.2135 -3063 6 3.33738 17.579 14.2816 -4.12164 13.1786 -2.02309 -3064 4 3.51487 16.7052 14.5979 -0.480238 -24.8864 6.17379 -3065 4 3.96197 18.0965 14.8055 -3.35437 6.17503 -1.46632 -3066 6 27.7248 11.5976 7.52038 4.0705 34.1711 4.34085 -3067 4 27.7194 12.5939 7.6487 2.26317 -33.1326 -4.66749 -3068 4 27.2616 11.2314 8.28138 -1.22149 -2.70865 2.4378 -3069 6 41.4317 28.339 9.02961 12.1835 18.6619 -21.5911 -3070 4 40.932 28.9387 9.57928 -8.65956 3.59764 13.3257 -3071 4 41.6711 28.9179 8.26221 -0.754142 -18.9314 12.3863 -3072 6 42.0732 4.78493 8.18399 0.592074 10.501 -23.0953 -3073 4 42.2656 5.73441 7.90258 -4.03181 -32.5079 3.94615 -3074 4 41.9391 4.19656 7.39311 5.50228 24.8072 19.85 -3075 6 28.4553 8.6408 40.3288 -1.1592 2.81238 -0.593175 -3076 4 27.8014 8.47839 41.05 3.29603 2.13238 -25.5829 -3077 4 28.0374 8.68456 39.4248 -2.58083 -3.24862 30.0681 -3078 6 0.723272 18.248 15.2854 4.61761 3.31073 11.0333 -3079 4 1.58056 18.1517 14.8782 17.0637 -0.561901 -5.4503 -3080 4 0.169553 17.7112 14.727 -13.9143 -7.94922 -7.42873 -3081 6 7.11829 16.2161 40.455 0.573222 -5.60735 -16.9123 -3082 4 7.21814 15.2583 40.7035 1.10072 25.2259 14.7352 -3083 4 7.17549 16.8833 41.1741 1.82325 -21.1089 2.38217 -3084 6 41.0856 8.6232 20.9154 1.44565 10.3804 -0.748136 -3085 4 40.3857 8.53297 20.2693 -12.0873 -13.8416 -3.91841 -3086 4 41.3541 9.53003 20.731 8.87844 6.62655 8.68036 -3087 6 31.7065 7.41805 37.5384 1.8504 0.880847 10.656 -3088 4 31.4927 7.12037 36.644 -5.569 -4.06437 0.235955 -3089 4 30.9766 7.14703 38.1182 6.88034 1.43502 -8.9471 -3090 6 40.7175 11.6353 25.4105 -5.83472 20.1078 -6.29096 -3091 4 40.8441 12.5768 25.6218 -9.59803 -8.51017 -7.38463 -3092 4 41.5254 11.2592 25.7328 13.3582 -17.7026 5.353 -3093 6 29.8893 30.1615 6.66958 6.45784 -4.04896 -4.41327 -3094 4 30.5285 30.6751 6.15191 0.92206 -5.81994 -1.29615 -3095 4 30.2313 29.249 6.64761 -0.535397 8.70224 -1.24193 -3096 6 40.83 24.591 5.67679 17.1105 23.9162 -4.99229 -3097 4 41.4401 25.3556 5.89599 -18.0089 -21.1831 -4.73113 -3098 4 40.1352 24.5742 6.32932 -4.29697 2.2625 8.62223 -3099 6 34.3954 9.09122 20.4203 -0.702674 2.95809 7.47625 -3100 4 33.5897 9.50113 20.7506 -0.63314 5.38769 7.97821 -3101 4 34.107 8.76785 19.5728 -0.194313 -9.82044 -16.4611 -3102 6 18.2164 33.5433 26.5438 32.3972 -29.6611 -30.5808 -3103 4 19.1929 33.4142 26.4527 -23.3283 -2.37285 -6.48837 -3104 4 18.1915 34.0681 27.3044 -13.0981 29.1765 42.7321 -3105 6 28.9207 17.4075 26.7926 -1.66434 -4.11711 9.90999 -3106 4 28.2497 17.0259 26.21 0.151798 0.605301 -3.15085 -3107 4 28.4243 17.7127 27.5796 8.50802 -3.38176 -8.48604 -3108 6 50.4389 35.5612 18.195 -0.220837 -24.3132 -9.08897 -3109 4 50.4331 35.2145 17.2813 -0.853004 14.3463 8.17747 -3110 4 50.3692 34.7248 18.6968 -4.07606 17.1918 3.62275 -3111 6 2.99582 21.5586 31.4575 0.708202 -18.646 -28.6731 -3112 4 3.24926 22.2892 30.8424 -5.67023 -11.8068 12.1364 -3113 4 2.8516 20.7624 30.8616 4.12476 24.3831 20.6408 -3114 6 36.1857 18.7483 8.60511 9.96184 26.1081 -2.68835 -3115 4 36.1356 17.8778 8.93402 3.95956 -36.7917 21.724 -3116 4 35.6171 18.7388 7.85438 -14.2398 9.24248 -24.4438 -3117 6 20.2742 6.47995 33.7286 -0.427153 4.78104 -4.08195 -3118 4 19.8935 6.35632 34.6244 -2.14212 -11.6635 -12.611 -3119 4 20.0876 5.70362 33.1559 -1.45185 1.76636 16.8362 -3120 6 13.9952 30.5211 6.65468 -0.834568 0.374695 7.89925 -3121 4 14.6781 31.0539 7.1149 -10.4447 -7.07426 -7.17019 -3122 4 13.1432 30.7212 7.07951 7.79461 1.02333 -2.73826 -3123 6 36.2732 16.4484 35.7639 18.345 14.0335 0.961522 -3124 4 37.2268 16.2475 35.9495 -24.6333 8.21497 -3.5549 -3125 4 36.1837 17.4253 35.5797 7.74798 -29.1845 4.36862 -3126 6 45.8208 37.6575 9.69399 14.3507 -31.8621 -27.6249 -3127 4 45.4608 38.3019 10.268 -8.06385 16.394 26.7739 -3128 4 46.3975 37.0305 10.1733 -1.81999 10.6315 0.898341 -3129 6 47.4165 17.984 27.6369 4.10759 -46.3966 -5.45297 -3130 4 47.5682 17.4629 26.7823 -7.01073 17.4072 30.8444 -3131 4 47.4562 17.3293 28.4007 0.542452 20.9274 -25.5144 -3132 6 25.9608 18.2932 0.952258 -4.39486 21.5955 18.9376 -3133 4 26.1989 18.9101 1.66086 12.5057 -8.35286 -7.15646 -3134 4 25.0082 18.3237 1.04468 -12.1408 -13.2893 -13.6751 -3135 6 27.3648 22.4066 4.28268 2.26175 -24.9034 0.419816 -3136 4 27.3706 23.3409 4.46802 1.80952 16.8807 -5.51915 -3137 4 27.3027 22.2785 3.32806 -2.77408 5.10873 4.5687 -3138 6 3.39125 3.84856 27.607 3.69966 -10.1033 0.490887 -3139 4 4.0137 4.55908 27.5406 6.78149 24.6072 0.911673 -3140 4 3.97847 3.09168 27.5281 -8.4044 -12.3732 0.103181 -3141 6 45.3633 27.6554 28.8452 2.12727 -1.25659 10.7713 -3142 4 44.5282 27.2015 28.6866 -4.83999 -4.58212 3.48715 -3143 4 45.3811 28.2979 28.14 4.63148 6.41932 -6.37453 -3144 6 28.4005 32.3772 16.2203 23.7034 -3.75626 0.763822 -3145 4 29.2297 32.2225 15.6968 -18.0553 4.16843 14.9752 -3146 4 28.6795 32.6874 17.1033 -0.325788 -1.29005 -11.6373 -3147 6 9.90477 33.835 13.0292 3.70295 -3.7397 30.9684 -3148 4 9.58558 33.3049 13.7992 6.56164 12.5415 -12.6178 -3149 4 9.32425 33.6546 12.2978 -12.2649 -3.83445 -16.8068 -3150 6 38.3301 26.6316 14.917 8.16845 -9.374 -1.40965 -3151 4 38.7482 25.7736 15.154 -10.3234 14.7528 -2.05039 -3152 4 37.3847 26.6122 15.1206 3.66029 -5.29 2.35016 -3153 6 31.3553 16.3729 4.24558 -11.5598 -13.3523 13.2112 -3154 4 30.5395 15.8971 4.54084 13.4071 7.11555 -7.19651 -3155 4 31.205 16.607 3.32285 -2.62497 2.93757 -4.30077 -3156 6 6.17611 3.41063 6.5613 17.7272 3.64487 37.5473 -3157 4 6.46982 3.08663 7.46094 -9.0795 17.2981 -27.883 -3158 4 6.02642 2.6045 6.08389 -2.81663 -13.5692 -12.3872 -3159 6 42.5919 12.9938 5.62253 0.302259 -11.3067 -0.460125 -3160 4 42.3001 13.8766 5.84478 4.87778 6.39543 1.2284 -3161 4 43.5084 12.9049 5.92305 -2.35353 0.46184 -1.33783 -3162 6 41.0467 31.3953 33.7949 3.79599 37.3117 5.16998 -3163 4 40.7289 31.3961 34.7173 5.05156 -5.30154 -15.2916 -3164 4 41.2174 32.3636 33.5809 -4.47671 -37.1445 4.47908 -3165 6 52.8595 12.0576 26.2617 4.7779 -12.5882 -49.4794 -3166 4 52.3971 12.713 26.7564 -13.8804 18.303 15.9364 -3167 4 52.6839 12.2865 25.2977 8.87889 -9.64762 29.5111 -3168 6 39.2197 4.29237 29.0569 11.235 6.95972 3.08537 -3169 4 38.4782 4.84799 29.3396 4.36118 -6.50894 -4.0878 -3170 4 39.9967 4.59393 29.5615 -4.77927 -7.36273 -4.89832 -3171 6 3.64414 27.0065 11.2815 -12.9441 10.9516 -6.43872 -3172 4 4.59106 26.8908 11.2849 14.3058 -9.72403 4.26042 -3173 4 3.53535 27.8319 10.7781 -8.82957 -2.80904 -0.131447 -3174 6 41.5421 29.6442 25.2671 -5.6293 3.19366 2.66863 -3175 4 41.8684 29.6903 24.3723 12.1179 -3.11764 -10.4285 -3176 4 40.7194 30.1326 25.2057 -6.30215 2.63585 1.74894 -3177 6 50.468 27.487 30.6705 -3.05594 -10.4468 2.57161 -3178 4 50.076 27.1594 31.5009 0.806547 4.01213 -5.24181 -3179 4 49.8217 28.0451 30.2184 -2.62753 1.96724 1.87939 -3180 6 32.7902 33.6258 41.7496 -4.87138 -4.97834 -25.0012 -3181 4 33.1641 32.7497 41.8541 3.47816 -11.5824 1.65798 -3182 4 32.8969 34.0586 0.665858 3.16614 12.7166 21.4132 -3183 6 5.9796 9.64598 7.93234 5.57207 13.1841 -10.7861 -3184 4 5.80592 9.95912 8.82583 -0.986272 -0.521215 4.5825 -3185 4 6.43021 10.3852 7.47125 -1.05258 -10.6241 3.31462 -3186 6 52.774 25.3768 27.6816 12.7732 -3.18466 28.0173 -3187 4 52.93 26.2779 28.0237 -8.60677 -10.695 -13.1321 -3188 4 53.2011 24.8527 28.4031 -8.37753 -2.27765 -26.5487 -3189 6 18.6947 23.2095 14.4724 -28.0966 8.43578 15.8218 -3190 4 18.5587 24.1605 14.7523 20.6562 -24.296 -13.1918 -3191 4 19.5669 23.0215 14.1303 11.4888 10.4676 -1.8787 -3192 6 31.2862 9.0706 13.0896 18.8649 -43.5027 -8.26415 -3193 4 31.2854 8.18164 13.5153 -0.98006 14.2242 -7.24428 -3194 4 30.8139 9.64196 13.6614 -21.2648 23.3567 24.384 -3195 6 52.8349 16.8368 29.9626 -1.04236 -5.83632 -3.7224 -3196 4 53.1314 16.3317 29.1809 4.11254 10.2245 6.81583 -3197 4 53.5336 17.4658 30.2088 5.59995 -2.32318 -6.64835 -3198 6 13.48 30.6403 11.9185 -26.7 12.8254 18.6299 -3199 4 12.8874 31.2649 12.4086 6.11749 -21.3055 -11.69 -3200 4 14.2712 31.1662 11.9231 18.3999 3.72963 -5.07782 -3201 6 24.4118 24.6653 11.1776 -11.0488 -38.9105 0.0232616 -3202 4 25.2327 25.0345 11.4834 15.6111 8.28781 8.86477 -3203 4 24.5324 23.6736 11.237 -9.01076 27.817 -2.51724 -3204 6 11.1207 26.7925 5.93063 -6.41259 2.09364 -8.23675 -3205 4 11.5241 26.98 6.79711 -3.12879 8.72791 -6.17468 -3206 4 10.8719 27.6544 5.50988 6.7003 -18.2386 15.7162 -3207 6 12.0069 32.3194 4.56559 -6.93674 1.89769 -53.2748 -3208 4 11.7104 31.8608 3.68045 16.1117 25.2499 46.2442 -3209 4 12.3686 33.2222 4.3326 -9.20365 -26.1492 2.14142 -3210 6 6.43611 5.48582 30.4705 10.9412 7.27018 -5.81208 -3211 4 6.8324 6.31983 30.1884 15.302 -0.761667 0.276275 -3212 4 5.5204 5.70213 30.4126 -22.6187 -2.98333 3.5448 -3213 6 38.1723 39.6045 29.3805 -11.1368 -0.968084 -7.99101 -3214 4 37.5332 40.3179 29.1036 12.1085 -24.1545 -0.917311 -3215 4 37.9804 38.7063 28.9788 -2.28765 36.4506 5.30967 -3216 6 52.5924 19.3736 5.41149 4.12965 0.0949992 -5.17576 -3217 4 52.3027 20.2712 5.07121 22.7239 -28.0308 -2.84369 -3218 4 53.4989 19.0543 5.10701 -28.7609 25.7225 2.66162 -3219 6 18.3561 9.81057 21.0683 -18.476 -24.6523 15.6829 -3220 4 17.6378 9.45854 20.4828 20.1245 14.4878 5.80252 -3221 4 19.033 10.2869 20.5982 6.82627 10.6552 -20.9713 -3222 6 14.5094 41.1238 15.0395 5.73538 -4.06503 -13.1796 -3223 4 15.2839 41.068 15.6075 4.55031 0.900939 7.74817 -3224 4 13.875 41.6599 15.5263 0.0235554 2.15182 4.98288 -3225 6 36.0027 23.903 26.7597 7.48895 21.6763 -35.676 -3226 4 35.8975 23.6043 27.6465 2.36908 -17.7227 17.2904 -3227 4 36.3267 23.2124 26.1374 -7.97178 4.49324 27.7844 -3228 6 35.6359 10.4157 26.2529 -13.2839 -25.1837 23.1485 -3229 4 35.969 10.5098 25.3716 5.3977 0.436992 -21.1808 -3230 4 35.4229 9.45302 26.3798 5.18698 20.1527 -7.56493 -3231 6 45.3037 24.2791 20.2723 9.06075 11.2998 -13.4968 -3232 4 45.4523 24.978 19.6109 10.2075 -1.49386 4.95329 -3233 4 44.5125 23.8555 19.9662 -13.3892 -9.58217 -2.04663 -3234 6 15.8107 39.0453 24.2393 9.7405 19.086 8.48056 -3235 4 15.3407 39.8143 24.6455 3.07287 -17.6695 -6.90152 -3236 4 16.7434 39.3626 24.1878 -22.1708 -8.11019 0.25747 -3237 6 4.61074 25.9041 16.8066 4.47487 12.325 4.32837 -3238 4 5.33363 26.3313 17.2996 -1.16871 -8.95741 -3.63592 -3239 4 3.89121 26.5439 16.91 5.27726 -3.71411 -3.28281 -3240 6 33.4791 9.99232 32.5716 -36.5508 -4.76722 -31.2046 -3241 4 34.3147 10.2419 32.89 39.2476 10.968 21.6954 -3242 4 33.0188 9.57531 33.3002 0.324125 -5.12222 10.2577 -3243 6 22.9388 37.5185 1.51191 -4.27166 -24.2064 8.31852 -3244 4 23.0334 38.2273 2.154 1.20614 3.86272 6.71724 -3245 4 22.69 36.6978 2.02191 6.96614 23.4315 -10.5782 -3246 6 39.1324 20.5485 25.4772 25.265 -11.778 19.9951 -3247 4 39.2103 21.4279 25.1215 -1.526 12.0473 -3.88318 -3248 4 39.8813 20.4818 26.1301 -17.748 -0.0581828 -14.4699 -3249 6 25.0622 25.0762 37.6014 21.4558 5.76047 -13.7935 -3250 4 26.0349 25.2337 37.6294 -19.4467 -8.38624 -4.14531 -3251 4 24.8891 24.8197 38.5048 -7.65564 -1.94532 12.2316 -3252 6 12.209 35.7591 11.4203 -9.12536 1.25056 -5.53999 -3253 4 11.4995 36.2015 10.8899 19.2305 -11.6187 8.3526 -3254 4 12.8486 35.4161 10.7797 -5.71729 7.89629 -2.43108 -3255 6 42.046 15.7235 20.1276 29.9467 5.46844 -26.2367 -3256 4 42.5818 15.5034 19.3148 -14.0105 1.75231 17.5608 -3257 4 42.3615 16.6209 20.337 -4.0808 -2.27778 2.90042 -3258 6 53.2021 25.4307 39.5282 4.69599 -13.2561 7.07883 -3259 4 53.78 25.8541 38.905 5.49131 5.5629 -6.42231 -3260 4 52.4802 26.028 39.6966 -10.1139 9.50655 0.821399 -3261 6 53.7967 21.778 1.29815 15.5744 -8.20383 1.43914 -3262 4 54.6378 21.4326 0.944441 -3.84265 -1.46767 8.18122 -3263 4 53.3536 22.1543 0.542634 -13.037 9.31425 -11.6048 -3264 6 1.93111 22.4438 20.1768 4.00387 4.12813 31.1185 -3265 4 1.5939 23.2361 20.6593 2.49828 -13.4199 -15.2591 -3266 4 2.41139 21.9607 20.8911 -6.34657 6.89732 -14.8434 -3267 6 41.1871 16.1847 11.4932 0.836017 42.0531 1.99799 -3268 4 40.9413 15.3195 11.802 -9.8633 -17.6073 7.87469 -3269 4 40.5377 16.8617 11.8588 16.4331 -27.7799 -8.96912 -3270 6 17.194 38.6096 9.61825 4.75854 -2.20459 -16.4638 -3271 4 17.8324 38.6167 10.328 10.0816 -0.610832 12.429 -3272 4 16.3385 38.6013 10.0398 -14.9506 0.593169 11.9887 -3273 6 33.2005 12.9606 38.531 8.50507 10.8774 -15.8661 -3274 4 33.6532 13.8203 38.39 -7.98235 -13.7359 5.26797 -3275 4 33.1331 12.8007 39.479 5.11874 5.24255 -4.23095 -3276 6 24.7171 21.675 39.9778 2.8762 -23.2501 -10.2076 -3277 4 24.5558 21.597 39.0096 0.45736 0.189324 11.8412 -3278 4 25.3262 20.9394 40.2143 -5.83632 9.86919 -3.30671 -3279 6 13.5803 15.5602 27.3532 26.1047 30.3564 11.1382 -3280 4 13.1676 16.145 28.014 -3.26959 -8.19558 -5.9347 -3281 4 12.973 14.8589 27.1951 -20.4184 -17.1677 1.43072 -3282 6 24.68 18.7128 9.26691 14.3839 36.3501 26.0009 -3283 4 25.3598 19.2552 8.82532 -5.31062 -15.6251 -9.27674 -3284 4 24.5166 19.2286 10.0937 -4.12977 -20.8661 -14.1648 -3285 6 10.971 8.2031 0.0820528 -5.05885 27.6393 52.7366 -3286 4 10.426 8.82187 0.676738 20.6953 -23.692 -21.2054 -3287 4 11.8511 8.19112 0.51746 -10.8092 -0.715691 -8.01276 -3288 6 15.7168 31.9426 31.3882 -16.0589 -14.8784 11.374 -3289 4 14.8784 32.0139 30.9212 -5.19427 4.39929 -5.1125 -3290 4 16.2361 32.7208 31.1626 4.51908 -4.85975 -1.07492 -3291 6 20.3853 39.1678 21.6201 3.96912 1.70678 -2.15463 -3292 4 19.8408 38.4031 21.9136 18.3946 15.2484 5.21077 -3293 4 21.1259 39.3411 22.2478 -18.5683 -14.4588 -3.61544 -3294 6 38.8575 19.5345 7.60357 -3.22682 7.2187 -10.7103 -3295 4 37.9955 19.1157 7.58645 -3.56529 1.50397 -1.646 -3296 4 39.2183 19.2349 8.43232 7.58358 -7.76078 7.45775 -3297 6 41.3566 29.7161 21.1634 -18.4754 -13.1658 17.2704 -3298 4 41.7904 29.7702 20.3348 3.95998 3.00501 -30.3792 -3299 4 42.0386 30.0045 21.7486 9.4821 7.67994 22.7786 -3300 6 50.7055 33.8359 22.0677 10.0235 -14.5617 12.8511 -3301 4 51.0634 32.983 22.4061 -4.7136 19.0099 -8.42991 -3302 4 50.4062 33.6539 21.1646 0.0172424 0.211956 1.78818 -3303 6 18.1576 11.1602 14.3564 -14.1594 -3.53412 4.86119 -3304 4 18.0624 11.3441 15.3149 3.69196 -2.83217 -14.991 -3305 4 19.1071 11.0831 14.1997 2.21718 -0.861887 0.62752 -3306 6 48.509 14.2737 15.2536 -33.8512 -15.7039 -13.3543 -3307 4 49.4102 14.4821 15.4142 31.3042 4.03673 3.1002 -3308 4 48.4635 13.5769 14.5611 0.497508 10.2707 10.4073 -3309 6 32.9892 15.7452 8.24788 15.5762 1.59093 3.47394 -3310 4 33.8184 15.532 7.78513 -5.99942 0.288096 4.45585 -3311 4 33.1922 15.7362 9.20789 -3.05234 -0.622843 -13.6288 -3312 6 42.9176 4.85532 18.7629 14.1748 1.41964 3.40057 -3313 4 42.9882 5.82921 18.9229 4.77982 -22.1758 1.39114 -3314 4 43.8043 4.45344 18.9624 -18.3785 17.0247 -7.93082 -3315 6 10.5031 23.7237 33.4382 -0.874073 19.9298 2.74355 -3316 4 10.5548 24.717 33.3795 7.7257 -28.8706 -7.54496 -3317 4 11.1379 23.281 32.8547 0.735263 11.3428 1.89897 -3318 6 1.13216 20.0583 11.2836 18.374 17.5884 12.1148 -3319 4 0.491024 19.3349 11.1994 -2.17247 3.20995 10.4498 -3320 4 1.13554 20.5377 12.169 -13.4236 -25.5013 -29.3002 -3321 6 1.52072 39.5358 14.3069 -1.86369 -19.4721 11.7014 -3322 4 0.846705 40.1803 14.5938 4.14733 -5.95668 -5.60613 -3323 4 1.29368 38.6598 14.724 6.32152 28.9753 -9.07681 -3324 6 8.31775 21.6111 14.1387 -15.017 -6.93379 31.3726 -3325 4 8.13664 21.1659 15.0266 4.22851 15.111 -30.7591 -3326 4 7.52757 21.5034 13.5919 -1.9589 1.09648 1.01763 -3327 6 7.16491 13.3069 38.2405 -3.91014 1.61314 -29.5843 -3328 4 6.63698 13.0539 37.4502 4.01765 -4.94514 23.7112 -3329 4 7.51249 14.1719 37.966 2.17516 -8.38294 10.659 -3330 6 46.6268 1.62726 18.6981 -5.20766 -2.9114 16.5849 -3331 4 47.5711 1.68468 18.9367 -9.38594 -0.162468 5.90612 -3332 4 46.1191 1.48652 19.5414 20.1897 3.23395 -16.531 -3333 6 4.07867 8.38347 14.797 30.0262 18.9917 2.43531 -3334 4 3.34187 8.3175 15.3794 -25.1937 -7.21885 10.0707 -3335 4 3.92422 7.81173 14.052 -7.87119 -13.0009 -15.9092 -3336 6 47.5843 36.535 17.848 27.4213 12.0237 5.93301 -3337 4 47.2301 35.69 17.6416 -25.9655 -28.1947 -7.00186 -3338 4 48.5203 36.321 17.8356 11.6458 7.4707 2.49139 -3339 6 48.7172 32.6081 3.62434 16.9155 19.6851 -27.3563 -3340 4 49.4676 32.1613 3.18145 -8.8052 -0.0369675 17.0972 -3341 4 48.3534 32.1141 4.33579 -5.12692 -24.8974 22.5299 -3342 6 26.8624 34.4063 15.194 -5.61502 8.38998 -0.355377 -3343 4 27.128 33.6719 15.7603 3.91671 -4.37186 -8.54489 -3344 4 27.3784 34.3384 14.3661 -3.09932 -5.4603 13.6569 -3345 6 9.98983 27.3411 13.3236 -5.30345 -60.6937 -19.0037 -3346 4 9.94192 28.2179 13.0053 -1.51785 37.2293 -13.4128 -3347 4 9.87191 26.7487 12.5139 4.66007 24.2176 27.9858 -3348 6 2.39898 26.8872 37.357 1.59401 -7.29113 19.9813 -3349 4 2.39832 26.7504 38.3162 -5.28205 -0.510768 -0.23331 -3350 4 3.33711 26.9514 37.1904 14.8183 3.44774 -11.9786 -3351 6 33.3368 17.2756 36.8005 -23.2882 7.84328 1.94786 -3352 4 32.371 17.4043 36.8526 5.24602 0.476467 11.7287 -3353 4 33.4423 17.1515 35.8622 12.5187 -3.29866 -15.2334 -3354 6 10.6624 18.8035 9.30575 -3.98781 15.2275 -14.7508 -3355 4 10.7339 18.764 8.32616 -2.59554 -5.92059 15.2764 -3356 4 10.8972 19.732 9.49452 -1.55193 -6.4517 3.37647 -3357 6 8.57833 27.4047 3.14019 -5.09403 -6.13324 -2.85576 -3358 4 8.57126 27.6547 4.08504 -2.7611 -8.03155 -6.83353 -3359 4 8.4622 26.4231 3.09919 3.19624 23.0742 12.9307 -3360 6 40.6073 33.9264 14.3399 -6.85038 20.2562 -23.9123 -3361 4 40.863 33.245 14.948 0.807967 -8.16399 15.1571 -3362 4 40.0779 34.5716 14.8204 -0.495244 -4.69725 4.10141 -3363 6 53.9925 16.7992 13.6308 6.31935 -7.9338 28.1888 -3364 4 54.0997 17.1551 12.7528 -11.031 14.1585 -18.9596 -3365 4 53.1709 17.0486 14.0912 -3.14305 7.59696 -13.573 -3366 6 39.1497 38.4912 7.40608 -39.1223 4.05884 30.5073 -3367 4 38.8859 38.5922 6.48797 -2.00378 4.08479 -3.77896 -3368 4 38.3062 38.5986 7.97667 35.5804 -2.74434 -28.8566 -3369 6 42.2129 33.6808 29.0138 -24.1371 3.42921 -11.8129 -3370 4 42.1057 34.6378 28.7577 -2.98627 -25.8941 0.854821 -3371 4 41.3475 33.1819 28.8496 28.8118 27.0492 8.45917 -3372 6 2.85866 0.0629173 20.1315 -20.2536 1.52979 -19.4947 -3373 4 2.75203 0.421025 19.2221 8.85994 -2.20895 9.93397 -3374 4 1.96017 41.6124 20.299 15.6791 2.4666 6.01858 -3375 6 24.986 26.9373 24.4454 -5.13687 18.0728 7.96565 -3376 4 25.2851 26.0172 24.3926 4.88984 -3.86206 4.04103 -3377 4 25.2923 27.4081 25.2509 0.579281 -17.4573 -11.648 -3378 6 13.6179 33.9875 7.01366 -9.87556 12.4155 -39.0476 -3379 4 14.4287 33.6264 6.65472 5.99816 -4.92128 6.68342 -3380 4 13.2096 34.3429 6.17379 4.4552 -5.00021 31.0775 -3381 6 17.6494 31.8378 3.38868 3.47258 32.8259 -24.0658 -3382 4 17.3179 32.0585 2.49435 6.00696 -1.44586 18.975 -3383 4 17.3532 30.9566 3.5196 -11.0767 -31.773 11.9025 -3384 6 31.1111 29.8483 35.9167 13.6376 7.61418 -14.6842 -3385 4 30.4141 29.611 36.5018 -19.519 -6.65958 16.6428 -3386 4 31.8988 29.4329 36.2727 4.98993 0.410401 2.8928 -3387 6 31.4643 1.69164 1.93808 20.5111 47.6543 28.2436 -3388 4 30.8038 1.05919 1.86135 -35.916 -50.7273 -13.0106 -3389 4 30.9957 2.32106 2.5233 13.9145 -2.66096 -10.7861 -3390 6 13.7147 9.36591 12.3063 -10.8769 -31.3803 3.40225 -3391 4 14.006 10.2311 12.0687 5.19854 25.7457 4.3425 -3392 4 13.2135 9.34561 13.1466 7.78847 9.513 -6.56361 -3393 6 15.2882 15.1512 12.1315 -28.7349 -8.10496 1.75886 -3394 4 14.285 15.1274 12.2085 32.3197 -4.02875 -3.81405 -3395 4 15.5527 14.5676 11.4001 -6.69875 1.91641 1.76342 -3396 6 44.9132 30.4441 13.088 -39.1187 -0.31911 18.6923 -3397 4 45.3561 30.6438 13.8967 -2.95974 2.37903 28.1101 -3398 4 45.6316 30.4633 12.5179 38.3165 -3.24606 -51.9295 -3399 6 35.1465 37.623 24.8576 -14.1582 -15.7359 28.7413 -3400 4 34.5779 38.3725 25.1706 10.6028 -16.3472 -5.82963 -3401 4 34.9593 36.856 25.4995 5.71155 29.9045 -22.7235 -3402 6 43.8948 19.2936 12.9987 -2.30513 -18.2146 13.0469 -3403 4 43.787 18.3102 12.9069 2.76315 21.1578 4.09431 -3404 4 44.375 19.4187 13.8444 -6.58761 -4.34429 -6.9628 -3405 6 14.1971 27.3925 16.8971 2.69526 11.3314 -20.1154 -3406 4 13.4533 26.7979 16.9981 -2.42546 -10.6182 5.16389 -3407 4 14.0783 27.734 15.9851 5.1255 -3.8968 13.4589 -3408 6 5.08574 37.4729 15.7377 1.34169 3.72011 38.8669 -3409 4 5.88395 37.4897 16.2981 -4.65405 2.63162 7.63907 -3410 4 5.46406 37.2335 14.9215 11.9791 -13.9554 -41.5179 -3411 6 35.4862 36.9766 33.2333 -36.83 -5.70901 2.9599 -3412 4 36.4114 37.1444 33.1615 28.5824 10.2327 4.96708 -3413 4 35.1164 37.4942 33.9725 5.15458 -1.79752 -2.84758 -3414 6 6.636 31.7097 32.9848 -22.7133 -7.33235 -24.9389 -3415 4 7.22761 30.9741 32.8206 4.14198 -5.34147 5.16294 -3416 4 6.9999 32.2337 33.6789 14.5784 9.31919 13.8511 -3417 6 31.283 20.2175 25.4647 -9.91499 -1.61286 9.73388 -3418 4 30.5344 20.24 26.1037 18.6204 0.149313 -5.83605 -3419 4 30.8734 20.4846 24.6365 -0.167457 4.09649 -2.99843 -3420 6 54.9487 26.0868 7.35258 -28.6285 -0.216784 1.76255 -3421 4 54.2955 26.5615 6.794 6.74078 -5.97369 7.99882 -3422 4 54.4034 25.6757 8.0611 9.89476 6.61779 -10.5703 -3423 6 17.8651 35.1614 24.3791 -20.7499 -4.98646 -29.5673 -3424 4 18.0576 34.6235 25.1649 -8.37985 -1.7243 -11.1178 -3425 4 17.2007 34.681 23.779 26.831 10.1018 28.2803 -3426 6 49.1285 3.31358 19.7417 -8.45795 -3.91869 -17.1851 -3427 4 48.8119 4.11203 20.1653 -3.29153 9.9905 4.05996 -3428 4 49.7807 2.96094 20.3466 4.32541 -4.85853 3.16639 -3429 6 30.2844 35.6035 13.4934 7.2001 -0.317469 -2.452 -3430 4 29.4623 35.659 12.9857 1.71884 -1.71824 2.45729 -3431 4 30.0585 35.4328 14.4204 -4.00669 1.3983 -5.34585 -3432 6 43.3887 25.8808 41.6785 -22.9069 -12.3923 -2.55701 -3433 4 43.9997 25.6768 40.9817 12.0928 0.211006 -14.0269 -3434 4 43.8339 26.4255 0.397834 14.8568 14.8319 19.2759 -3435 6 21.0884 23.1529 6.38678 -1.35916 1.28851 13.8592 -3436 4 21.4 23.8645 6.98768 -5.78702 -12.5756 -9.70729 -3437 4 21.3246 23.4545 5.51028 2.40121 5.3387 -13.5131 -3438 6 54.6143 21.1989 19.0895 1.0726 18.3039 13.0104 -3439 4 0.43531 21.5582 19.5367 -15.0683 -8.68203 -12.1911 -3440 4 53.867 21.7044 19.4937 16.3508 -9.47613 -7.9193 -3441 6 13.877 38.9443 18.7624 -3.57764 -10.5141 -5.7706 -3442 4 13.4493 38.4672 19.4981 1.6116 7.10734 -3.21136 -3443 4 14.0821 39.8514 19.0249 -5.40993 2.00969 6.25434 -3444 6 39.1872 2.73234 39.6824 0.14108 0.727177 -8.14712 -3445 4 38.529 2.27328 40.2354 4.03816 -1.16808 -5.22543 -3446 4 39.0548 2.41866 38.7627 -6.48078 -0.982324 12.2661 -3447 6 43.2185 33.8148 8.84061 -19.4182 46.8926 -2.36482 -3448 4 43.1772 32.9719 9.24022 -1.50187 -35.3898 17.2737 -3449 4 42.5163 34.3616 9.29053 19.0727 -15.0644 -10.6104 -3450 6 23.089 16.6827 12.1027 15.7208 -3.2574 -7.89972 -3451 4 23.4385 16.1911 11.3228 -11.6069 8.24456 13.4993 -3452 4 22.136 16.8018 11.9813 0.424679 -1.38664 -3.29845 -3453 6 40.7855 26.1389 36.3196 -19.9126 19.309 9.87347 -3454 4 40.0986 26.8534 36.2514 19.4153 -21.5003 1.38126 -3455 4 41.1517 26.0031 35.4437 4.25962 0.995192 -8.54639 -3456 6 15.1503 11.6717 19.2973 0.724699 -1.19191 17.6918 -3457 4 15.5299 12.2877 18.6792 5.27756 8.7759 -18.41 -3458 4 15.4868 12.0294 20.1269 -4.65024 -4.08223 3.58338 -3459 6 9.86165 29.8154 31.387 -8.94942 -10.7424 5.06077 -3460 4 10.5846 30.1184 31.9716 0.245343 7.83947 -17.0155 -3461 4 9.856 30.1645 30.4637 12.8302 0.479173 21.4055 -3462 6 2.12473 30.035 25.2763 1.78753 8.3758 2.85176 -3463 4 2.08519 29.2167 25.7943 1.54705 3.16986 -12.4779 -3464 4 2.12365 29.8679 24.3136 0.147535 -6.31004 19.3474 -3465 6 49.0081 10.6471 7.05663 3.22839 15.7191 0.010386 -3466 4 49.8069 10.5015 7.59507 -11.7369 -5.9273 -2.35907 -3467 4 48.4474 9.86293 7.09337 3.15572 -10.0552 5.75386 -3468 6 38.6524 34.4248 32.4903 14.0617 12.8107 -4.97275 -3469 4 38.3124 35.2999 32.7524 2.4491 -7.54743 -1.61947 -3470 4 38.3152 33.7696 33.1015 -5.90625 -1.07654 6.02858 -3471 6 24.2925 24.7077 4.76791 -9.60212 12.423 13.627 -3472 4 24.6592 23.9059 5.14091 6.4374 -12.2494 -4.05598 -3473 4 24.0877 25.2629 5.55261 2.76703 -5.61196 -18.2913 -3474 6 44.0394 23.5955 33.7722 -22.1761 -10.7316 25.8053 -3475 4 43.54 23.0408 33.1405 14.8275 10.6039 0.934173 -3476 4 44.7909 24.0173 33.3845 18.136 8.68259 -21.6513 -3477 6 45.1404 31.9557 26.6336 7.63501 -16.8517 -19.5705 -3478 4 44.7419 32.078 27.4825 -5.98757 6.26965 19.5048 -3479 4 44.9572 31.0195 26.4087 0.928196 13.8489 4.22851 -3480 6 52.067 6.35346 22.8527 -23.4258 -19.9992 -0.226773 -3481 4 51.4359 5.65775 23.1792 22.6487 15.1416 -4.78776 -3482 4 51.473 7.11391 22.7826 5.97124 1.02094 -2.8274 -3483 6 5.11659 17.7141 30.4608 -43.6072 -14.7819 8.36724 -3484 4 5.56343 17.5578 29.6371 20.9412 3.52217 -11.7922 -3485 4 5.63141 18.2128 31.0754 22.7819 13.5036 5.79607 -3486 6 48.537 17.0137 6.52887 28.2349 12.1042 -25.3981 -3487 4 48.2628 16.1023 6.56372 -5.81913 -12.4107 2.5618 -3488 4 49.2494 17.0592 5.82246 -25.6562 2.24824 21.9849 -3489 6 13.808 31.3142 23.4689 -3.64011 -9.68131 26.3432 -3490 4 14.1349 31.2178 24.3617 -12.0329 4.75192 12.2102 -3491 4 14.6149 31.173 23.0226 30.8248 -5.26015 -34.1434 -3492 6 28.4946 33.4369 26.0285 16.4638 25.2333 -6.25798 -3493 4 28.7216 32.7387 25.4298 8.48672 -9.67688 -13.795 -3494 4 27.7897 33.0868 26.5316 -24.4903 -9.494 23.2581 -3495 6 9.0435 22.9594 11.008 21.162 0.605596 1.29652 -3496 4 9.33306 22.7779 10.1087 -4.82127 0.713158 -4.26872 -3497 4 9.8456 22.7632 11.5172 -9.5186 2.48902 2.0044 -3498 6 40.5545 4.06728 26.5809 44.6249 -53.7912 6.90123 -3499 4 40.0988 4.06982 27.4038 -17.0162 4.47424 24.8249 -3500 4 40.1579 4.71783 26.0744 -31.5116 46.4114 -32.7723 -3501 6 17.0554 37.9737 20.9489 23.2001 5.84937 -15.1211 -3502 4 17.8184 37.6206 21.4529 -18.1961 -0.773306 2.14347 -3503 4 16.241 37.9215 21.4323 -8.54619 -6.77157 16.0583 -3504 6 31.9589 6.36634 14.2007 -32.7312 -5.18635 1.31695 -3505 4 31.6173 5.45206 14.3159 2.63352 8.72785 -2.4018 -3506 4 32.9006 6.25378 14.1536 18.2531 -4.45925 -0.605861 -3507 6 29.3682 34.9487 39.6588 1.61784 2.82525 -17.5597 -3508 4 29.3689 34.7576 40.5935 -6.77547 -0.101859 12.4897 -3509 4 28.4273 35.0463 39.4168 8.43037 -3.37269 4.33216 -3510 6 22.5699 2.93494 32.1141 -1.63629 -8.86743 4.25418 -3511 4 23.0898 3.67063 31.7669 1.49018 1.71101 -1.29845 -3512 4 22.818 2.15292 31.5827 -1.92581 11.5593 5.09528 -3513 6 51.7444 19.0899 24.8018 18.5566 14.3159 27.8709 -3514 4 52.1262 19.3991 25.6728 -16.855 -8.06891 -29.5747 -3515 4 52.1578 19.634 24.1129 -3.61196 1.33098 2.20453 -3516 6 32.1137 13.664 24.2226 6.2567 1.72658 -37.8727 -3517 4 32.2307 13.7857 25.1378 6.97488 6.10606 45.7276 -3518 4 31.1794 13.5551 24.0935 -22.8325 -3.39176 -1.92521 -3519 6 9.48788 30.1788 28.8037 -7.90151 -0.480281 -10.0021 -3520 4 9.04214 29.3907 28.4657 0.296662 -4.58444 4.12418 -3521 4 9.71381 30.648 27.9899 1.85323 2.91474 4.33114 -3522 6 31.3027 3.12343 24.087 3.70677 4.08208 -3.18372 -3523 4 30.8363 3.94541 23.9161 -7.21645 -1.79011 2.75115 -3524 4 32.1629 3.26377 23.6687 3.35255 -5.74571 3.4439 -3525 6 2.14326 19.8385 36.4613 43.5578 -10.0216 -16.9659 -3526 4 3.05142 19.7594 36.0352 -31.8637 8.98539 19.2185 -3527 4 1.69253 19.0555 36.1346 -14.6763 0.545221 1.96285 -3528 6 36.957 16.7591 14.0918 2.96563 -13.2358 -6.51153 -3529 4 37.0513 17.1687 14.9682 1.23982 -3.45998 -2.6752 -3530 4 37.3406 15.8552 14.1067 -4.20166 12.9403 2.86695 -3531 6 1.82327 11.1921 6.0808 -0.275886 9.47834 -4.04825 -3532 4 1.66503 10.3513 6.51275 0.636708 -7.94921 -0.277572 -3533 4 1.41092 11.8149 6.68093 -3.53423 6.76721 2.7814 -3534 6 43.1526 36.8455 25.2619 -8.14588 -11.3328 3.19442 -3535 4 42.3648 36.774 24.6888 4.17675 -0.750929 11.0286 -3536 4 43.0263 36.2034 25.9927 3.18182 11.8936 -13.2388 -3537 6 32.1279 5.54767 7.01242 2.49094 2.37791 -5.83138 -3538 4 31.9279 4.68363 7.38152 0.218816 -4.41428 4.71371 -3539 4 31.563 6.18782 7.45455 -6.02642 2.24751 5.27561 -3540 6 15.066 21.4965 41.5173 26.6113 -14.2353 0.879596 -3541 4 14.4098 21.4318 0.299313 -13.8163 5.2854 1.00244 -3542 4 14.7314 21.9782 40.7628 -14.3918 6.6959 -6.38566 -3543 6 37.0263 36.0654 5.67599 -8.66989 11.0394 5.08886 -3544 4 36.7926 36.9074 5.26668 1.42879 3.21556 -9.50708 -3545 4 36.6993 36.1724 6.58455 6.67811 -8.44617 -2.15326 -3546 6 39.6264 22.8802 0.345968 -6.61229 0.0560669 1.87747 -3547 4 39.9979 23.7083 41.9266 1.97423 1.58642 1.0556 -3548 4 39.8106 22.8717 1.30105 -0.716498 -2.72173 1.5866 -3549 6 18.4762 23.1875 5.24196 -3.43754 -16.0644 -0.1002 -3550 4 18.2109 24.0785 4.97873 9.26343 12.8459 2.1419 -3551 4 19.3202 23.1705 5.73113 -5.23082 11.7415 -3.58503 -3552 6 34.4866 26.3931 0.410981 -26.1443 -19.9516 50.1306 -3553 4 33.9706 27.0567 0.94736 13.8106 -10.3269 -20.7381 -3554 4 34.4077 25.5868 1.01915 10.7474 25.1704 -28.4611 -3555 6 28.1474 26.0925 40.6196 -28.5345 -18.6936 36.4955 -3556 4 29.0529 26.0026 40.9247 9.18224 2.32741 -2.79367 -3557 4 27.6107 25.644 41.3519 15.6172 17.8969 -31.6189 -3558 6 41.7482 4.39863 30.2421 -5.41295 4.8086 27.4354 -3559 4 42.5847 3.93131 30.2216 8.80522 -6.59194 -7.61494 -3560 4 41.6924 4.68152 31.1831 -5.94926 -0.146025 -12.4776 -3561 6 4.45598 8.30655 29.1222 20.5127 -16.5965 8.52389 -3562 4 3.66946 8.7156 28.7677 -9.60933 13.4518 -0.978151 -3563 4 4.96147 8.97819 29.6123 -10.8114 0.933443 -7.64816 -3564 6 12.9096 9.61234 32.1411 7.95239 -11.3181 7.67023 -3565 4 12.5174 8.82681 31.7782 -9.40951 -4.97415 -8.25208 -3566 4 13.381 9.26623 32.9076 3.83436 11.6436 3.42456 -3567 6 48.6608 16.2478 1.44826 -41.5847 5.12436 -2.24268 -3568 4 49.5977 16.2655 1.51923 27.6715 2.95254 13.2549 -3569 4 48.2356 16.5221 2.2956 18.9339 -8.30142 -14.6437 -3570 6 26.4307 40.0076 21.1903 -9.81311 41.2665 6.04236 -3571 4 27.1749 40.6498 21.1967 -8.04845 -12.0635 0.822588 -3572 4 26.7755 39.1508 21.0026 13.0624 -20.4442 -2.17563 -3573 6 35.79 4.08177 9.00682 -31.6066 0.334495 -4.41207 -3574 4 35.483 4.74976 8.36033 1.0784 -4.66377 5.72074 -3575 4 35.0087 3.86601 9.59196 22.2264 5.21899 -16.6494 -3576 6 52.6895 3.55332 27.8634 16.2443 -8.90238 -17.7273 -3577 4 53.4861 3.5089 28.4695 -19.2533 -5.0216 -23.8454 -3578 4 52.9436 3.34738 26.8904 -3.28408 11.0051 45.9059 -3579 6 48.3169 26.6974 27.3926 25.9077 -23.6746 5.28014 -3580 4 49.0048 25.9927 27.5456 -25.7263 19.495 -6.18754 -3581 4 48.6886 27.4598 27.8411 -2.12981 11.4596 4.51315 -3582 6 24.5097 4.95686 18.7286 -11.1396 -9.34012 13.2359 -3583 4 24.0942 4.18073 19.1756 8.31772 16.1923 -9.35863 -3584 4 23.9484 5.73893 18.8892 6.66511 -10.1227 -0.689949 -3585 6 24.0567 12.4804 28.7686 -1.83015 0.889486 -1.95598 -3586 4 23.1997 12.8888 28.9043 -2.54864 9.49841 4.61676 -3587 4 23.8244 11.6446 28.3683 7.90245 -6.62953 -5.67748 -3588 6 40.1561 27.7426 40.8073 -21.5317 7.14576 -7.35733 -3589 4 40.4932 26.962 41.2601 -12.917 0.0491148 -0.726507 -3590 4 39.1936 27.5721 40.6401 25.9681 1.33069 1.19471 -3591 6 11.9274 13.5458 26.9496 -4.40765 -1.96337 -6.60028 -3592 4 10.9986 13.6678 27.167 -4.51497 -1.32563 0.190923 -3593 4 12.2404 12.8654 27.5442 6.31176 -11.0874 3.59056 -3594 6 52.1902 29.5387 41.394 18.594 -11.3781 3.59259 -3595 4 51.989 30.3087 0.0068425 -9.85392 15.5397 4.91192 -3596 4 53.1003 29.3208 41.6912 -5.64389 -6.04423 -8.59676 -3597 6 17.4867 19.0227 39.1838 -6.27455 21.666 2.75279 -3598 4 17.488 19.586 40.0024 0.860103 -14.9947 -21.9977 -3599 4 17.2876 19.5951 38.4014 5.36511 -12.0476 21.2649 -3600 6 46.2283 27.6807 33.7144 -6.74129 13.676 11.5468 -3601 4 46.0876 28.3582 33.0447 4.86435 -1.49715 -10.0026 -3602 4 45.6533 27.9743 34.4365 0.457797 -3.70748 6.99028 -3603 6 35.8353 29.5439 5.61992 2.49906 -1.59566 -19.7219 -3604 4 35.6527 29.5233 4.66367 4.90114 -0.621078 3.19465 -3605 4 35.4473 30.3766 5.88547 -3.82587 11.7884 10.6864 -3606 6 47.2822 25.7798 30.1513 -10.5766 8.53329 -17.9568 -3607 4 48.1664 25.813 29.7363 -13.2628 3.84456 1.19765 -3608 4 46.6616 26.387 29.6551 21.0058 -12.1546 6.47151 -3609 6 51.3953 12.3638 20.0228 -1.62023 8.46277 -4.73872 -3610 4 50.7529 12.7462 19.4094 4.65296 3.97806 -1.37635 -3611 4 50.8736 11.6867 20.4477 2.10356 -10.8225 11.04 -3612 6 41.9857 18.3757 28.9464 12.9674 -8.39178 -20.9845 -3613 4 42.6678 18.0249 28.3214 -8.5661 8.58724 12.8041 -3614 4 42.4509 18.9846 29.5329 1.95722 -2.13958 -2.01301 -3615 6 53.5955 6.47736 7.49747 -17.4879 -34.0434 -11.6994 -3616 4 53.215 5.56736 7.34717 12.2612 27.0176 1.32153 -3617 4 53.8473 6.47025 8.42428 8.27981 0.813073 3.28926 -3618 6 9.90701 10.6092 26.7593 2.25524 -7.80823 -0.160956 -3619 4 10.2937 10.2906 27.6083 -8.74192 13.2514 -11.8083 -3620 4 9.6719 11.5504 26.8324 5.3909 -8.28719 7.73453 -3621 6 9.32838 39.4044 29.7661 28.1478 19.087 17.9947 -3622 4 10.1636 39.3682 30.3277 -29.6144 2.71186 -18.0569 -3623 4 8.79772 40.1574 30.1092 9.7156 -13.1012 -9.05156 -3624 6 33.3969 4.77935 0.0338577 7.04977 -8.48101 -1.75146 -3625 4 33.7652 5.5373 41.4968 -3.54645 16.0087 -2.35532 -3626 4 34.1271 4.15493 41.8774 -6.76144 -3.49152 6.70786 -3627 6 35.7118 10.6691 34.2465 30.5451 -20.2214 -10.6481 -3628 4 35.199 10.7815 35.0349 -14.696 6.44481 20.012 -3629 4 36.4515 10.0721 34.5187 -16.7263 14.6249 -6.06398 -3630 6 15.1941 17.3851 19.1797 2.70911 -28.1342 -44 -3631 4 15.4897 16.9339 18.3047 -12.3876 19.7973 41.7399 -3632 4 14.2542 17.5546 19.0074 0.407714 2.19657 2.29796 -3633 6 17.478 37.6645 15.4329 -18.9254 1.45878 17.8737 -3634 4 16.9549 37.8023 16.2867 26.4617 -7.60783 -22.0624 -3635 4 18.4074 37.4659 15.6333 -6.79317 3.25497 7.31584 -3636 6 26.2497 8.20945 21.7084 13.406 8.66037 11.1677 -3637 4 26.4123 8.51714 22.643 -13.4745 -7.28424 -22.9055 -3638 4 25.3027 8.1176 21.5293 -5.49097 3.27453 10.4234 -3639 6 0.34 9.90937 15.4047 -28.932 15.8312 -5.67551 -3640 4 1.21626 9.57115 15.2747 8.47529 -16.8828 -5.88536 -3641 4 54.6903 9.41637 14.8207 22.8064 6.49071 10.4803 -3642 6 13.4564 40.6532 9.29599 -22.1307 -5.15585 -0.326819 -3643 4 12.4714 40.4452 9.30279 34.033 7.20134 3.90171 -3644 4 13.9359 39.9749 9.79874 -9.44555 -0.536228 -2.64909 -3645 6 49.5525 25.9167 33.0087 8.30289 -20.978 36.7812 -3646 4 50.1102 25.581 33.7998 -31.2394 16.5759 -41.6702 -3647 4 48.6381 25.5592 33.0807 18.1841 3.33668 -0.378289 -3648 6 37.0921 40.0433 26.4323 -69.9693 32.9093 31.9949 -3649 4 36.1848 39.6472 26.7001 50.2617 0.87061 -16.3943 -3650 4 36.887 40.9984 26.66 23.4133 -30.5831 -16.8038 -3651 6 47.9876 17.8592 12.1588 -8.21233 14.3088 -32.1086 -3652 4 47.5845 18.6288 11.6747 8.44083 -19.6159 16.8154 -3653 4 47.7143 17.8826 13.0665 -7.39134 3.08395 19.3289 -3654 6 27.9663 29.0642 34.1603 1.53587 -18.0299 -1.74725 -3655 4 28.882 28.804 34.3498 -7.37789 1.41773 -2.30399 -3656 4 27.9529 30.0159 34.1809 1.22694 21.8088 1.61581 -3657 6 34.0029 2.78452 13.2168 -24.1529 16.185 8.10865 -3658 4 33.6393 2.32953 13.9926 -4.91269 2.52718 -2.68734 -3659 4 34.7844 2.29731 13.0428 30.2788 -14.7346 -8.06408 -3660 6 28.44 36.053 11.4482 -19.9886 -0.916941 20.5685 -3661 4 28.0041 35.3416 10.9605 0.296796 1.69001 -2.92558 -3662 4 29.0597 36.4216 10.8465 18.9417 8.99323 -20.1084 -3663 6 36.1834 11.364 28.8528 2.80179 -1.8504 -16.6465 -3664 4 35.2026 11.3648 28.9433 17.0081 -1.44193 -10.527 -3665 4 36.4266 11.2403 27.8881 -16.5332 2.0664 24.3605 -3666 6 24.8155 39.488 16.899 1.95651 8.69094 -17.2938 -3667 4 24.2729 40.277 17.0547 2.68209 -2.76325 7.28198 -3668 4 24.7648 39.3887 15.9322 -0.898649 -0.731043 6.96785 -3669 6 49.9432 8.0514 22.8505 -60.8038 -24.1516 -13.0827 -3670 4 49.7668 7.94962 23.7845 10.2147 3.57848 16.1239 -3671 4 49.0378 7.75433 22.5026 41.2245 11.1916 1.13457 -3672 6 52.0935 19.338 10.2277 12.6357 -4.19253 18.0692 -3673 4 51.6063 19.2592 9.39778 1.74616 10.4418 -3.52762 -3674 4 52.4735 20.2434 10.294 -12.5007 -15.5081 -12.5544 -3675 6 24.8386 15.8838 6.12895 -18.3448 14.0073 -0.236232 -3676 4 24.2024 16.3229 6.74681 14.2411 -11.6767 -8.77744 -3677 4 24.4989 16.1625 5.25788 7.11766 -3.93298 6.13727 -3678 6 49.3148 23.6851 8.6303 24.9689 -39.379 16.691 -3679 4 49.2746 22.9584 9.31909 -7.63259 29.9964 -23.4819 -3680 4 48.4638 24.0489 8.3953 -15.5352 0.433996 3.53825 -3681 6 0.208059 10.6481 32.1797 22.1875 -2.28391 4.69689 -3682 4 1.08388 10.2912 32.3483 11.827 -2.86298 -20.6213 -3683 4 54.878 10.581 33.0649 -30.4469 3.74284 18.7822 -3684 6 12.5874 32.9143 13.2407 -35.4131 4.94433 4.95913 -3685 4 11.7345 33.4182 13.1185 22.1299 -14.9844 2.19911 -3686 4 13.2795 33.4792 12.9271 13.1216 10.0242 -5.44208 -3687 6 21.734 32.5657 14.1089 -30.2641 -10.609 17.8788 -3688 4 21.1735 33.3586 14.1938 13.4775 0.171544 -7.80997 -3689 4 21.2373 31.9121 14.6504 18.4585 12.3126 -12.4653 -3690 6 48.1656 34.8484 27.3207 -34.4178 -12.3509 -32.6658 -3691 4 47.5287 35.1179 27.9926 9.598 2.53078 9.45385 -3692 4 47.5616 34.4813 26.6056 29.2581 12.2879 19.461 -3693 6 45.6153 31.2627 36.0943 -37.261 16.4569 21.0579 -3694 4 45.7916 31.8927 35.3904 -0.807743 4.61331 -8.81752 -3695 4 44.8366 31.6277 36.6156 19.759 -7.25665 -17.1647 -3696 6 46.2873 0.296503 14.3622 0.346279 -8.22198 0.0964187 -3697 4 46.2502 1.23933 14.2464 -13.6881 13.1616 4.37405 -3698 4 47.2018 42.0236 14.1712 14.709 -12.2876 -2.23521 -3699 6 14.3299 18.994 40.2006 -30.7379 -32.6603 -9.06287 -3700 4 14.4791 19.2338 39.2972 7.93482 8.11578 -14.4624 -3701 4 14.6855 19.6458 40.7662 17.9566 28.0241 18.1173 -3702 6 14.5596 1.14026 10.2341 26.3279 -2.23148 -9.5451 -3703 4 15.4055 1.22344 9.73443 -17.3894 7.51472 10.761 -3704 4 14.1379 0.381418 9.8097 -7.55267 -3.97863 3.86231 -3705 6 34.4334 40.9199 12.9894 -0.940803 4.29697 -17.7271 -3706 4 34.039 40.5607 12.1545 5.82782 2.6847 22.9711 -3707 4 34.273 40.3011 13.7266 -2.01031 0.481385 -16.696 -3708 6 42.1477 25.6267 33.9881 24.0417 -24.4569 -2.75436 -3709 4 41.6299 25.3559 33.2134 -0.0206438 0.202706 6.41118 -3710 4 42.855 24.9213 34.0976 -22.0628 21.5276 -5.85955 -3711 6 29.1852 22.5895 40.0737 -4.6165 -6.65381 -10.571 -3712 4 28.5947 23.1672 39.581 -0.582997 4.41945 3.85107 -3713 4 29.0675 22.7332 41.0074 -2.93269 3.94269 10.2267 -3714 6 44.8062 18.6252 1.49818 5.72139 3.58279 15.6322 -3715 4 44.9314 18.8801 2.44529 -3.9019 -2.65234 -18.9387 -3716 4 44.0985 19.1782 1.14518 3.29812 2.13948 3.69359 -3717 6 4.47265 10.8135 23.9407 -24.2902 -18.4562 11.3409 -3718 4 5.11906 11.4142 23.6391 22.3407 21.5355 -19.7447 -3719 4 4.51291 10.8829 24.8932 -6.80118 0.381125 6.4492 -3720 6 6.46087 23.0097 28.9948 -0.180046 29.3158 3.74757 -3721 4 7.16357 23.1777 29.6697 -12.977 -15.1924 -17.9731 -3722 4 6.42476 22.0762 28.8013 7.623 -17.0728 6.50296 -3723 6 39.796 25.1427 32.5747 9.70804 -1.04373 -32.2987 -3724 4 39.5377 25.4516 33.4106 -12.9416 11.3784 38.6909 -3725 4 39.6539 25.9218 32.0211 1.09764 -5.16827 -8.54386 -3726 6 40.8629 21.4836 8.86543 0.741147 13.6451 -7.24725 -3727 4 40.6441 21.3431 7.92826 2.29745 -6.5969 8.98303 -3728 4 41.3236 20.7041 9.20266 3.81714 -8.25026 -3.81722 -3729 6 0.635293 1.4289 12.9408 -11.8573 10.3167 -17.0811 -3730 4 54.7874 1.76314 12.6159 9.08744 8.74788 -10.2417 -3731 4 0.270536 0.805051 13.547 10.8795 -21.9384 23.5147 -3732 6 32.6734 29.7199 23.4842 -6.31159 -22.9731 3.95312 -3733 4 32.3164 28.805 23.472 7.37478 14.3791 4.20759 -3734 4 32.5291 29.9779 22.5736 0.738758 10.2783 -10.1223 -3735 6 12.5322 37.1564 20.4866 30.6876 51.3804 29.6269 -3736 4 13.0449 37.1468 21.3313 -10.4644 -1.04639 -16.0138 -3737 4 12.1935 36.3015 20.3752 -17.5174 -49.5479 -6.43685 -3738 6 13.879 14.5208 24.6979 -2.0089 -0.488943 14.0828 -3739 4 13.5126 15.2415 24.1863 -2.86121 7.01781 -5.24136 -3740 4 14.0435 14.8889 25.5812 -0.885703 0.504049 -6.33424 -3741 6 17.5084 27.0547 26.4789 25.7109 3.2743 -38.4356 -3742 4 17.3703 27.9297 26.0618 -4.07905 -12.769 13.7294 -3743 4 18.1097 26.6273 25.8042 -17.4354 5.34049 24.3014 -3744 6 54.4807 9.52867 26.3526 -8.08409 11.5192 21.059 -3745 4 54.0543 10.3952 26.5681 7.59002 -15.9534 -5.94965 -3746 4 54.8701 9.18952 27.1901 -5.85154 7.09102 -14.0848 -3747 6 33.6811 21.5047 24.9231 9.13792 -2.03882 -43.3211 -3748 4 33.6373 21.3676 23.9235 3.71376 4.25849 32.7793 -3749 4 32.846 21.1613 25.2346 -13.4677 -6.75943 10.2286 -3750 6 22.147 35.267 2.89295 -1.50127 3.24452 17.3348 -3751 4 22.2381 34.4 2.47628 0.948748 -2.82555 0.0189077 -3752 4 22.0999 35.1233 3.8735 0.523717 -2.91888 -18.7193 -3753 6 45.3111 5.3951 15.6139 -0.0233827 -18.9082 29.3701 -3754 4 45.1442 5.22798 16.5663 9.63366 2.6406 -14.7931 -3755 4 44.5125 5.84005 15.3428 -8.81534 4.22624 -14.6387 -3756 6 5.67663 7.59044 16.9735 -0.040306 4.08799 -12.5895 -3757 4 5.28026 7.88599 16.128 7.47401 -1.2917 10.5251 -3758 4 6.58383 7.937 17.01 -0.793937 -3.87211 -2.68331 -3759 6 34.58 39.0977 27.2045 1.42769 14.436 -3.31523 -3760 4 34.2907 38.4975 27.863 -0.77861 -26.0942 16.6839 -3761 4 34.0642 39.8725 27.4397 -1.42861 13.6713 -5.6929 -3762 6 32.7657 33.6085 34.293 -22.4583 20.5671 -18.6673 -3763 4 32.1806 34.0441 33.6111 23.9751 -17.2665 15.818 -3764 4 32.4638 34.0082 35.1245 2.30326 -6.42306 -1.86009 -3765 6 30.988 41.2133 32.384 -4.02481 -7.82035 -3.95856 -3766 4 30.2267 41.2202 32.9774 -4.32902 6.50081 -0.328838 -3767 4 31.0509 0.17511 32 -1.2051 10.1503 -2.92525 -3768 6 7.6493 1.59177 27.1464 22.3535 -22.6118 -16.4669 -3769 4 8.41104 1.29664 26.5499 -29.8997 15.2665 16.3611 -3770 4 7.54328 2.53873 27.061 4.65755 9.49162 -4.22239 -3771 6 0.888965 22.101 37.8501 15.4112 -23.8094 -16.9331 -3772 4 1.26739 21.3109 37.3638 -11.0686 24.0488 15.8162 -3773 4 1.18 22.8712 37.3372 -1.61814 -2.27923 2.93708 -3774 6 7.39632 11.121 19.2332 -2.86932 4.41375 3.62624 -3775 4 7.58751 12.0436 19.3904 -7.23274 18.3647 6.41875 -3776 4 8.29083 10.7877 19.1848 5.97481 -12.1861 -3.76707 -3777 6 43.7816 12.5054 37.3126 2.86093 2.78929 -1.28281 -3778 4 43.9727 12.4749 36.3586 -3.06612 0.785718 5.83621 -3779 4 44.6572 12.6706 37.7021 -4.14278 -2.20963 -1.61523 -3780 6 29.0947 33.5132 36.1777 7.61955 17.1376 -26.1106 -3781 4 29.8261 34.0815 35.8667 -13.5031 -6.20718 4.51186 -3782 4 29.4784 33.1216 36.9462 10.9925 -12.9866 20.6523 -3783 6 14.807 4.60084 3.93512 20.0881 9.19657 -13.3363 -3784 4 14.316 4.04064 3.33426 -13.0632 -7.60853 1.79497 -3785 4 15.6236 4.79338 3.42413 -10.111 -0.253003 10.8348 -3786 6 39.0437 6.41097 6.40143 -11.952 4.4329 11.9095 -3787 4 39.4604 7.16771 6.02322 8.12547 27.0605 -0.357881 -3788 4 39.3566 5.75952 5.7919 -0.567413 -21.3616 -5.48613 -3789 6 22.2146 37.9992 40.767 -9.02066 -17.4896 -19.1754 -3790 4 22.494 38.8839 40.5618 6.85259 22.4587 -5.93601 -3791 4 22.4583 37.8811 41.6743 4.99519 -4.33654 23.0463 -3792 6 4.4524 23.286 6.15211 29.8095 -7.21279 -13.1375 -3793 4 3.81791 23.938 6.45512 -14.4589 -6.71938 9.72163 -3794 4 4.31449 22.3781 6.49744 -8.68344 13.1635 4.00749 -3795 6 12.4271 23.7748 9.24631 -1.26755 4.43152 21.3749 -3796 4 11.5607 23.6235 8.88266 -11.7175 -2.77193 -9.11925 -3797 4 12.2509 24.3149 10.0432 11.3809 -1.60307 -13.9136 -3798 6 46.4989 15.2625 16.9679 -12.8481 -2.49131 10.8408 -3799 4 47.085 14.9252 16.2779 8.49272 6.07271 -3.86524 -3800 4 46.8927 16.0486 17.3753 9.61298 -1.72862 -3.23202 -3801 6 34.1182 27.164 19.7815 17.9289 -11.392 6.58771 -3802 4 34.8637 26.5005 19.7508 -17.7467 14.3364 5.12367 -3803 4 34.0077 27.4664 20.702 3.31322 -6.80894 -12.4792 -3804 6 46.9518 13.2225 35.1059 11.5726 -0.299351 34.0182 -3805 4 47.3951 14.0533 34.9197 -1.30218 2.22738 -12.772 -3806 4 46.5273 12.8898 34.3328 -6.46075 0.0352155 -21.0879 -3807 6 50.5846 18.7905 12.5321 0.161349 -2.47544 -10.5355 -3808 4 49.7474 18.3698 12.2516 10.3296 3.30344 0.704295 -3809 4 51.1853 18.7954 11.7538 -11.6392 0.795373 7.80699 -3810 6 32.4849 12.6316 31.9547 13.623 -32.1984 -17.1952 -3811 4 32.7548 11.6805 31.9646 -3.77817 17.5545 -6.43374 -3812 4 32.3724 12.7906 32.8759 -7.39939 11.2146 27.5789 -3813 6 6.21204 19.6856 10.0139 6.84548 18.8235 13.1049 -3814 4 6.54027 20.2383 9.28123 0.761161 -1.37122 2.72757 -3815 4 6.08461 20.3138 10.7689 1.69871 -13.3343 -16.4193 -3816 6 21.5267 21.5372 2.4283 -5.72751 11.2346 -5.82425 -3817 4 21.7624 21.5115 1.48057 4.80944 -6.6677 9.03128 -3818 4 21.9699 20.8013 2.88237 1.68469 2.19074 -10.3234 -3819 6 38.389 23.0803 17.19 -15.8009 11.2489 14.8144 -3820 4 38.843 23.3405 16.3672 7.30113 -17.2523 7.40945 -3821 4 38.5581 22.1678 17.4979 8.57434 6.38113 -15.3203 -3822 6 29.7009 24.9705 22.2505 40.9979 -45.9373 -29.6811 -3823 4 30.2007 24.9541 23.0531 3.51493 7.58579 28.6285 -3824 4 28.9709 25.5198 22.3387 -45.941 40.092 17.1582 -3825 6 30.3026 21.4444 37.7784 -57.0222 17.1687 -23.3742 -3826 4 30.3615 21.3347 36.805 9.38026 -2.23221 21.4717 -3827 4 29.3011 21.6413 37.9016 49.3444 -12.8915 1.59191 -3828 6 11.8723 11.7062 16.3108 -33.4349 -15.0686 -41.1118 -3829 4 11.3207 12.2631 16.8681 -3.98396 2.02201 -1.40695 -3830 4 11.3108 11.5232 15.4705 24.8968 9.48818 41.0096 -3831 6 5.70652 16.9717 10.4705 4.17204 -12.2255 5.26049 -3832 4 4.89872 17.0293 11.0039 1.44556 1.21447 -8.81597 -3833 4 5.85075 17.8293 10.0626 -3.65007 4.58518 2.58079 -3834 6 41.6977 34.1692 35.8837 -2.16171 7.35997 35.3278 -3835 4 41.9434 35.0359 36.2767 -7.39108 -12.3774 -11.2945 -3836 4 41.6554 34.2509 34.9408 0.248654 6.88642 -24.6778 -3837 6 33.755 1.15956 30.1148 26.9661 -5.30311 0.785489 -3838 4 32.8327 1.41064 30.2749 5.35845 -2.81639 19.5818 -3839 4 34.3082 0.981132 30.9387 -30.8845 7.54253 -18.2089 -3840 6 50.3537 18.6141 36.9811 22.0078 18.2711 -1.17075 -3841 4 50.0553 18.9081 37.8421 -3.0234 4.11827 7.26126 -3842 4 49.7241 17.9789 36.6994 -26.7065 -28.1871 -12.5747 -3843 6 24.6713 24.2747 40.2422 -22.5478 13.5437 8.83718 -3844 4 23.7682 24.4281 40.6159 16.469 -5.34198 -8.29501 -3845 4 24.8078 23.3187 40.2616 -1.76472 2.5507 -0.358513 -3846 6 37.3089 22.0315 23.2412 -5.67505 16.6134 8.34505 -3847 4 36.9227 21.8066 24.1113 8.4343 -8.15598 -10.5545 -3848 4 37.8295 21.3076 22.8826 1.63944 -5.88141 4.04288 -3849 6 48.4175 40.505 28.9613 -8.44239 17.3351 -31.8351 -3850 4 48.9168 41.2502 28.5701 -3.67522 -6.90368 3.5913 -3851 4 47.6498 40.4225 28.3398 9.75729 -4.39015 14.633 -3852 6 24.8456 8.73476 16.5822 -4.20971 0.107082 12.7896 -3853 4 25.4166 9.33437 17.0882 0.801486 -3.84637 -6.6671 -3854 4 25.3552 7.93888 16.3774 1.47583 -1.66023 -1.71228 -3855 6 19.2415 22.9983 32.4591 18.0731 -7.21062 -7.32059 -3856 4 18.4972 23.4837 32.0941 -3.55414 -1.2008 3.19393 -3857 4 18.9283 22.447 33.1757 -6.31405 0.951806 3.86493 -3858 6 3.33315 21.6719 22.4471 -31.3651 -15.1442 10.7623 -3859 4 2.72119 22.0562 23.134 20.4737 -7.45649 -18.1084 -3860 4 4.09369 22.238 22.38 14.9219 12.7334 2.89238 -3861 6 10.2287 20.327 12.827 -13.2346 -13.5387 -5.73443 -3862 4 9.59835 20.9044 13.2794 3.30523 -1.6991 -3.3419 -3863 4 9.66163 19.6709 12.3619 8.96671 11.3846 7.22783 -3864 6 9.52445 0.665703 25.3447 51.6699 36.9138 -22.1471 -3865 4 10.407 0.70007 25.8038 -28.3091 -11.588 2.11711 -3866 4 9.73816 1.30323 24.5834 -23.5062 -26.9191 23.3279 -3867 6 10.6629 40.7098 9.64162 -13.7092 -10.0604 -17.7529 -3868 4 10.6663 41.3337 10.3633 -2.25222 9.44489 9.13119 -3869 4 9.9177 40.9644 9.04966 14.1089 -1.91013 12.7496 -3870 6 46.3583 25.2138 32.6818 -7.00173 28.401 24.5039 -3871 4 46.1658 26.0815 33.1748 9.63216 -40.3762 -24.4036 -3872 4 46.6683 25.4845 31.8081 -0.340565 -0.626762 -0.366217 -3873 6 38.9398 3.19835 23.1062 35.7507 -3.98021 4.80576 -3874 4 38.0789 3.42388 22.7807 -21.691 0.0477325 0.592254 -3875 4 38.9606 2.6551 23.9199 -14.9585 3.95725 -7.0779 -3876 6 33.3518 23.6324 36.8776 -10.909 11.1506 22.2396 -3877 4 32.7475 23.7189 37.6717 16.9933 -10.7727 -23.1962 -3878 4 33.5054 24.5617 36.6454 5.48307 -3.56245 -8.14833 -3879 6 51.9403 33.327 25.4307 18.0164 46.0043 -41.5452 -3880 4 51.481 33.1217 26.2288 -14.6019 -1.8433 25.1586 -3881 4 51.8744 34.3335 25.2555 2.07578 -44.1738 12.4077 -3882 6 32.1773 25.016 33.1611 -3.65323 12.5958 -4.40686 -3883 4 32.7417 25.8243 33.1248 -13.2213 -13.5953 2.20315 -3884 4 31.2567 25.3353 32.9959 15.6883 -4.24783 1.324 -3885 6 51.2804 27.7082 39.5058 -12.4055 -13.8576 13.4454 -3886 4 51.6333 27.8214 38.6405 7.56348 -1.28822 -27.9214 -3887 4 51.668 28.4332 39.9759 4.38661 13.1583 16.7532 -3888 6 34.2776 28.325 17.2612 18.5433 -9.6807 0.726105 -3889 4 33.4618 28.7621 17.0499 -21.6526 10.7978 2.5619 -3890 4 34.2928 28.1986 18.2187 -4.64072 -2.98555 4.57564 -3891 6 36.914 8.0422 37.8636 -11.4128 -16.3489 28.1347 -3892 4 37.1972 8.46051 37.0352 12.2245 9.0272 12.2411 -3893 4 37.2151 8.41454 38.7513 -7.64029 -1.69915 -40.4466 -3894 6 34.8876 19.4054 6.12727 15.6033 7.52257 2.15709 -3895 4 34.0531 18.9355 6.15655 -6.74313 -1.04378 -1.75599 -3896 4 34.6977 20.3552 6.00766 0.606543 -4.24654 -1.2187 -3897 6 52.9513 9.46866 7.83406 2.51792 52.5995 -46.1577 -3898 4 52.8182 10.1965 7.1313 21.8169 -33.4663 26.408 -3899 4 52.1097 9.49548 8.25498 -20.9439 -11.3984 23.93 -3900 6 36.2784 5.48477 38.9735 -18.6298 -4.41122 2.56352 -3901 4 36.9459 5.47799 39.6359 15.3203 -14.8264 18.8091 -3902 4 36.5882 6.23606 38.5023 -2.18903 24.2959 -30.3279 -3903 6 10.0091 14.4595 13.4727 4.14065 20.8003 14.1725 -3904 4 10.1735 15.3719 13.8184 -7.35802 -17.2864 -8.75733 -3905 4 9.20522 14.5177 12.9398 -1.57173 0.82324 -0.279823 -3906 6 17.2166 24.3595 39.7866 10.3316 -24.6644 9.74438 -3907 4 16.8461 25.2181 39.6219 -11.8102 15.8188 2.99696 -3908 4 16.9967 24.0978 40.7081 2.51259 6.67153 -9.86646 -3909 6 49.0842 32.5535 7.76087 3.66191 -12.3496 8.85055 -3910 4 48.2705 33.0417 7.89853 -4.87459 2.09702 3.01394 -3911 4 49.5463 32.9698 7.04629 8.35168 7.01386 -14.6239 -3912 6 44.8849 24.3899 5.46806 25.9844 8.68062 13.8603 -3913 4 44.662 24.5947 6.37974 6.74107 7.22813 10.7323 -3914 4 44.0754 24.0079 5.20592 -32.7636 -20.0017 -25.3594 -3915 6 37.3054 29.188 32.8461 11.1431 -5.59449 16.1726 -3916 4 36.8523 29.4202 33.6742 6.83247 1.44061 -4.51415 -3917 4 36.6742 29.3068 32.1579 -22.7291 3.94299 -14.9304 -3918 6 0.907991 24.8221 21.2346 15.0832 19.7352 -4.57067 -3919 4 1.06453 25.2816 20.3717 -1.39622 -8.03116 21.3543 -3920 4 1.45755 25.2897 21.9154 -11.7661 -11.1398 -13.6241 -3921 6 53.0192 2.206 13.0014 -0.818186 11.5483 2.08343 -3922 4 52.7824 1.81345 13.8314 -6.90556 -15.4066 8.50991 -3923 4 53.4537 3.0128 13.31 2.83183 5.68595 -7.528 -3924 6 24.3052 33.9756 13.9324 20.4312 -11.5489 10.0229 -3925 4 23.7773 33.1726 14.1229 5.8111 10.1191 -2.33499 -3926 4 25.2169 33.8698 14.327 -30.0349 3.28274 -10.0023 -3927 6 40.9302 19.2912 0.318024 -15.3988 27.4065 1.86032 -3928 4 41.1581 18.3902 0.297675 9.36546 -44.4479 -0.119704 -3929 4 41.7646 19.7516 0.396104 7.20249 9.57203 1.55489 -3930 6 38.311 32.026 21.5914 -16.5672 24.1097 -12.7773 -3931 4 37.7777 31.3762 21.1012 4.07846 0.69211 1.97712 -3932 4 37.9765 32.9287 21.3171 8.34414 -28.994 10.9395 -3933 6 42.3062 34.9979 16.9676 -25.16 18.3345 5.87282 -3934 4 41.5364 35.0784 17.5803 19.0968 -0.611651 -8.13832 -3935 4 42.7061 34.1505 17.1117 7.13758 -14.417 1.0169 -3936 6 19.559 24.3289 21.9471 -10.3882 -39.985 28.3228 -3937 4 19.0651 23.5074 22.2416 22.0177 25.9498 -5.97634 -3938 4 18.911 24.732 21.3859 -10.0006 10.9377 -12.5795 -3939 6 21.0734 3.08215 14.9508 5.66735 1.93263 4.27485 -3940 4 21.953 3.50152 15.1067 -15.9394 -6.36392 -7.95302 -3941 4 20.9814 2.87634 14.0019 2.73511 2.88399 3.27523 -3942 6 16.4416 12.1461 28.5328 0.855962 3.79198 1.54672 -3943 4 16.9672 12.6551 29.168 -2.37031 -0.949071 -4.41291 -3944 4 15.802 12.7688 28.1665 0.405815 -3.95107 1.98596 -3945 6 29.5641 4.71626 21.7415 17.492 -20.3905 -14.0863 -3946 4 29.717 3.79719 21.4198 0.937107 17.7735 8.56359 -3947 4 28.6765 4.939 21.4721 -9.06619 5.19467 -0.439365 -3948 6 47.4133 12.088 13.4013 -19.6032 -12.6622 16.1152 -3949 4 46.7677 12.2286 12.6843 7.8139 0.82382 7.69043 -3950 4 46.8958 11.6888 14.1608 19.5987 16.3505 -27.3211 -3951 6 26.4348 0.0314913 5.59163 -38.6673 11.9556 1.59378 -3952 4 25.5144 0.513751 5.59151 44.3701 -31.5426 2.21012 -3953 4 26.2832 40.9933 5.84663 -4.6239 23.4679 -5.56234 -3954 6 20.8211 34.8097 41.3598 6.97593 19.5597 16.9804 -3955 4 20.8796 35.753 41.6458 -3.00787 -20.9192 -8.75426 -3956 4 21.5767 34.358 41.784 -4.89338 4.10004 -2.4608 -3957 6 12.6876 17.479 1.38718 -1.79098 16.5747 12.6529 -3958 4 12.721 17.2085 2.3151 1.79447 -6.15344 -4.56661 -3959 4 12.6249 16.7029 0.834077 -0.882684 -12.7315 -6.97767 -3960 6 30.0809 10.1879 8.41184 2.17826 -2.71045 -21.4672 -3961 4 29.3744 10.7602 8.07412 2.70218 -2.7161 1.39802 -3962 4 29.921 10.0821 9.33998 -2.4398 0.0699553 19.6849 -3963 6 36.338 5.45526 23.9203 5.99313 10.0946 16.1749 -3964 4 36.1182 6.35936 23.6236 3.48165 -5.42435 1.21963 -3965 4 37.0503 5.55216 24.5976 -11.7354 -2.45534 -11.6386 -3966 6 34.0137 39.9398 19.5054 17.9066 -9.75089 21.0607 -3967 4 34.5988 39.5452 20.1731 -15.7075 -1.02338 -1.83906 -3968 4 34.6431 40.5289 19.082 -7.6391 9.5881 -14.1485 -3969 6 25.1112 29.0201 17.0007 35.0878 36.529 -22.1514 -3970 4 24.4917 28.3695 17.2244 -30.3786 -36.8419 16.5077 -3971 4 24.8604 29.2867 16.1023 2.15056 -2.21883 6.37313 -3972 6 28.5036 21.3308 6.52422 21.0338 -5.55128 30.7615 -3973 4 28.0688 21.6386 5.71574 5.06238 16.4658 -0.926129 -3974 4 28.989 22.0506 7.05137 -24.5794 -13.751 -30.0602 -3975 6 18.6637 26.1498 0.432001 -8.53447 25.4727 10.2843 -3976 4 18.1393 25.3713 0.533905 -9.92127 -26.6833 -5.54807 -3977 4 18.1707 26.7698 1.00478 10.6071 3.27379 -7.60185 -3978 6 10.9817 29.7047 15.4617 -41.5317 11.7513 13.4553 -3979 4 11.6879 29.3608 14.9846 35.2501 -21.9962 -32.1318 -3980 4 11.3889 29.9926 16.2601 5.02956 8.45945 23.8164 -3981 6 33.4827 3.76017 10.5773 -2.41261 -0.304069 24.838 -3982 4 33.4731 3.39919 11.5182 2.46452 11.5285 -31.0446 -3983 4 33.5847 4.73535 10.6555 -0.240223 -15.9168 2.16837 -3984 6 12.2973 28.805 23.0387 -1.70787 -5.55619 5.61474 -3985 4 12.73 29.6571 22.9381 2.67417 5.94729 -0.690524 -3986 4 11.5024 28.994 23.5653 2.03311 -0.198261 -3.05575 -3987 6 13.0915 10.291 41.0216 -35.9662 5.53295 8.52282 -3988 4 13.8386 10.0408 41.5246 29.6538 -8.48465 17.7322 -3989 4 13.4107 10.5366 40.1733 8.17866 7.18603 -23.992 -3990 6 45.8162 29.981 22.3537 -23.4909 -34.782 -9.94688 -3991 4 46.3605 30.6906 22.6479 19.8522 18.211 11.3118 -3992 4 46.1638 29.1315 22.7274 -3.04842 19.9099 -5.39144 -3993 6 41.5671 12.1372 14.78 12.0724 6.03101 -10.0784 -3994 4 40.8481 12.1001 15.4119 -11.2612 -2.38036 6.73971 -3995 4 41.9114 13.0311 14.8874 5.93112 4.19505 -0.667369 -3996 6 18.1729 7.20363 24.1739 -28.0382 48.7978 3.52623 -3997 4 17.4064 7.85498 24.128 33.406 -18.9268 -1.93395 -3998 4 17.7199 6.38321 24.1568 -14.2968 -40.16 -0.285645 -3999 6 1.47767 28.308 7.57167 -25.5616 27.2209 -25.1393 -4000 4 0.827452 27.622 7.68711 2.49251 -16.9659 6.86802 -4001 4 0.906232 29.0217 7.18328 24.331 -5.18373 6.93061 -4002 6 11.3359 12.3164 24.0718 -23.8013 37.4997 -14.7667 -4003 4 11.6691 13.0224 24.6595 3.51665 -15.1291 3.43827 -4004 4 11.6925 11.4858 24.3227 20.8697 -21.176 20.4973 -4005 6 17.9852 40.4684 24.4198 -2.05389 -13.7174 33.2687 -4006 4 18.291 40.9889 23.6947 8.79563 24.1615 -11.819 -4007 4 17.8495 41.0209 25.2243 7.13458 -7.65509 -20.9696 -4008 6 25.5964 7.43792 34.0141 13.5012 12.0052 -20.5927 -4009 4 25.8913 7.969 33.2287 -3.90825 -14.1502 17.4414 -4010 4 24.6674 7.63663 34.1466 -9.57807 0.741149 3.27376 -4011 6 16.9692 36.3856 7.79034 -41.9934 -28.8773 9.66508 -4012 4 16.1027 35.9203 7.98218 37.4859 8.56847 -14.648 -4013 4 16.8197 37.2026 8.24874 12.7807 20.325 5.07796 -4014 6 12.4125 39.1679 36.8113 4.83627 -30.6012 -9.1357 -4015 4 13.2866 39.4994 36.9682 3.20673 22.8904 8.84646 -4016 4 12.7018 38.3069 36.4569 -23.4958 5.90479 1.90955 -4017 6 23.4443 1.91649 37.7131 1.30421 0.985484 -2.89526 -4018 4 22.7028 1.66545 37.1374 7.60384 11.2995 4.79583 -4019 4 23.7753 2.79308 37.4363 -6.35903 -5.24233 -3.11404 -4020 6 26.6169 34.8556 39.068 -18.8945 24.0174 -16.1573 -4021 4 25.9011 35.0209 39.7003 9.00825 -5.11239 -0.809586 -4022 4 26.448 35.531 38.356 7.64302 -20.2436 14.8851 -4023 6 44.7566 35.572 23.174 8.53117 -4.94531 -21.3447 -4024 4 44.5551 36.3183 23.7275 -7.66893 11.3086 12.1688 -4025 4 44.9082 35.9286 22.2729 -0.906387 -11.1819 10.3159 -4026 6 34.6091 35.4265 26.6991 -7.96701 8.74937 -1.29134 -4027 4 33.7558 35.2865 27.1578 16.0802 3.93421 -4.37465 -4028 4 35.2785 35.5457 27.4013 -9.86041 -2.80018 -4.60569 -4029 6 12.4308 29.8402 9.37325 4.00701 15.5633 13.1387 -4030 4 12.6298 30.2095 10.2592 0.427445 -8.8693 -11.9579 -4031 4 11.9163 30.5385 8.94302 -0.259504 -4.09781 -0.505047 -4032 6 46.4536 41.3715 16.9585 -0.509472 -10.7221 -3.48983 -4033 4 46.3968 0.20327 17.5639 0.209317 7.43894 6.10767 -4034 4 46.3711 41.769 16.0793 0.075994 -2.20044 0.741492 -4035 6 39.1811 31.047 24.0166 -28.3946 14.7902 -31.7872 -4036 4 39.0009 31.2944 23.0615 15.0891 -8.50563 28.3067 -4037 4 38.282 31.1199 24.3765 13.6746 -2.33731 7.34059 -4038 6 40.5375 9.75603 28.9763 9.47615 -22.8392 -16.3574 -4039 4 40.717 8.78834 28.9749 -4.02124 18.0325 0.597023 -4040 4 40.0442 9.94417 29.7674 -4.45736 4.50836 13.2228 -4041 6 33.5752 11.9033 22.735 -22.7947 23.9621 15.9921 -4042 4 33.2963 12.1808 21.8555 7.18969 -8.33444 -8.87292 -4043 4 33.0376 12.5465 23.2695 22.9257 -24.0379 -3.52442 -4044 6 29.0301 38.739 2.44557 13.7604 -11.9544 -20.6568 -4045 4 29.2066 39.6607 2.23242 1.09325 2.62923 1.14408 -4046 4 28.4566 38.7797 3.20164 -8.68487 1.4276 10.4377 -4047 6 51.2789 6.14828 28.303 0.614736 -0.570337 1.8431 -4048 4 51.6973 5.27456 28.1665 -1.53436 11.093 -0.261734 -4049 4 51.6265 6.73477 27.6091 2.17001 -12.1019 4.10374 -4050 6 34.1129 16.6124 14.0322 -32.0491 -20.8609 -4.49638 -4051 4 33.8537 17.5241 13.9801 -4.99199 17.3104 -1.82528 -4052 4 35.0495 16.5739 14.0336 36.3732 5.94549 -0.19423 -4053 6 34.4398 40.0505 7.51971 -1.5967 1.86622 -34.5907 -4054 4 34.4907 40.736 6.82898 6.47702 11.7366 29.0204 -4055 4 34.1466 39.3906 6.89306 -3.09667 -23.6565 15.965 -4056 6 42.5416 22.9885 4.36731 16.709 1.02816 -9.65968 -4057 4 42.6773 23.0677 3.40021 -12.3994 2.37358 9.8727 -4058 4 41.6332 23.2481 4.59133 5.34809 1.54884 -5.45539 -4059 6 1.43335 11.7249 10.5915 17.9648 34.7983 -1.93775 -4060 4 2.18855 11.6351 9.93392 -25.2532 9.63542 18.7746 -4061 4 1.3761 12.7012 10.8984 13.7257 -41.7135 -20.7702 -4062 6 10.0197 17.1509 40.4023 -3.34945 -21.541 12.0793 -4063 4 9.07741 16.8499 40.449 26.596 5.40866 2.75879 -4064 4 10.6028 16.482 40.874 -24.6204 18.7768 -14.392 -4065 6 26.3793 1.16939 23.7984 9.5834 26.112 -20.0106 -4066 4 26.3482 1.63114 22.915 -1.08564 -15.7005 23.7132 -4067 4 26.8817 1.81632 24.3342 -3.35925 -10.5223 -0.68284 -4068 6 4.47487 16.2271 39.0058 33.4959 -10.553 -10.6989 -4069 4 4.63618 15.8937 38.0801 -2.33968 7.70086 24.4633 -4070 4 5.35244 16.1813 39.5129 -32.5033 1.65679 -19.7071 -4071 6 24.3835 39.8482 14.0852 2.84697 7.18038 -0.286146 -4072 4 24.1877 40.6985 13.6429 5.77715 -11.144 2.19115 -4073 4 25.1234 39.4426 13.6288 0.754333 1.29636 -3.16103 -4074 6 19.9701 19.0136 10.1131 -5.22385 -12.8057 23.8822 -4075 4 19.1001 19.3633 10.3498 -0.643873 5.13605 -7.14836 -4076 4 20.1315 18.3631 10.8504 3.64009 16.176 -24.2707 -4077 6 45.2329 15.0638 25.3099 -19.5547 20.2245 12.2671 -4078 4 44.4482 15.622 25.4263 4.62838 7.04728 2.57625 -4079 4 44.8851 14.3824 24.752 0.155489 -22.5403 -14.0061 -4080 6 47.6439 32.9533 29.9771 4.38746 -1.69347 6.40492 -4081 4 47.8622 32.5347 30.8309 -5.05982 6.77924 -7.14273 -4082 4 46.6855 33.0215 29.8843 -3.06966 -4.44082 4.14054 -4083 6 9.30872 14.1631 35.6268 19.7088 14.7601 29.7215 -4084 4 10.221 13.8687 35.4779 -5.99131 -8.3331 -9.89462 -4085 4 9.36538 14.5282 36.5395 -10.4264 -5.45721 -18.9107 -4086 6 0.534978 28.7509 32.1461 -15.0727 14.1973 -4.1115 -4087 4 0.468283 29.1163 31.2513 -2.72678 6.96628 5.64212 -4088 4 0.834469 27.866 31.9601 7.81775 -11.1437 7.49829 -4089 6 26.1375 14.1816 40.8286 20.1166 -40.7048 30.4826 -4090 4 26.3241 13.5573 41.5993 3.0023 20.8863 -27.3959 -4091 4 25.2151 14.3343 40.9319 -22.5068 13.4131 -3.44564 -4092 6 38.0468 1.72227 37.358 -19.6589 11.4537 -4.22791 -4093 4 38.2764 1.77906 36.4154 -1.14244 -2.14966 7.97792 -4094 4 37.182 2.20858 37.4052 20.9639 -13.8426 2.93072 -4095 6 43.3928 21.0193 0.385094 -33.4221 -4.11839 13.5226 -4096 4 43.2305 21.8771 0.864972 20.5484 -13.2955 -16.2126 -4097 4 44.243 20.9573 41.8451 7.78799 18.4844 3.58779 -4098 6 29.7343 12.3918 17.0888 -10.4088 14.6249 -44.7733 -4099 4 30.3573 13.1084 17.3121 -1.69191 -12.5137 15.8564 -4100 4 29.5365 11.7717 17.7855 9.28071 1.18848 24.195 -4101 6 21.0845 11.002 35.643 19.2467 11.9534 29.728 -4102 4 20.8387 11.9292 35.5336 -5.23529 -0.657509 -1.91086 -4103 4 20.6782 10.509 34.9529 -15.7216 -13.7754 -25.5995 -4104 6 24.3584 22.1274 17.054 -19.116 4.6391 -13.6617 -4105 4 24.8062 22.8618 16.6504 0.246813 15.5697 -7.02352 -4106 4 25.0581 21.6899 17.4914 19.3443 -19.237 19.9016 -4107 6 44.2632 9.62803 6.15095 12.4515 -7.11379 4.41615 -4108 4 44.6939 9.46248 5.31272 4.1824 -3.3463 -6.13814 -4109 4 43.3875 9.94101 5.94426 -13.441 6.05535 2.74078 -4110 6 40.7983 2.89203 6.29118 6.30341 -5.06299 2.94692 -4111 4 40.283 3.08384 7.0886 -2.93464 8.08246 -11.2803 -4112 4 40.6425 3.53992 5.58152 -5.48248 3.30556 7.46891 -4113 6 23.4927 29.787 25.2074 -17.9847 -14.6764 23.1638 -4114 4 22.9663 29.9524 24.4255 0.505661 2.84572 -7.25135 -4115 4 24.3189 30.243 25.1366 19.4862 15.0746 -12.06 -4116 6 45.2253 20.6067 7.48804 -4.5495 -5.9569 -0.737791 -4117 4 44.4771 20.6075 6.85512 7.98227 -4.73543 5.3389 -4118 4 45.4897 19.6858 7.65762 -3.7219 7.49041 -4.48952 -4119 6 44.1869 26.5802 16.6604 -2.53584 -23.4697 22.3036 -4120 4 44.4278 26.4187 15.7655 11.491 9.41288 -34.0672 -4121 4 43.9629 25.6676 16.9 -3.51956 3.82806 13.7521 -4122 6 23.5847 27.0608 18.0875 4.92857 -1.63386 -8.1099 -4123 4 23.1417 26.2886 17.6568 -1.85204 16.5134 12.3838 -4124 4 22.9956 27.5067 18.7318 1.2523 -15.787 -12.8337 -4125 6 45.1423 16.1006 8.91925 -12.5826 4.07054 -12.5551 -4126 4 44.1756 16.0018 8.7625 13.8686 2.25455 7.61002 -4127 4 45.2849 15.9649 9.86163 -1.87368 -3.25302 7.37304 -4128 6 39.0195 15.168 5.20911 22.9796 -5.95468 -13.3261 -4129 4 39.8169 15.5451 4.76197 -16.8333 -0.501818 4.44847 -4130 4 38.2997 15.7872 5.12886 -6.79784 14.0419 -3.1922 -4131 6 40.4728 4.77172 20.098 -25.5728 -7.96759 5.38455 -4132 4 41.2852 4.73631 19.62 25.1414 0.345713 -9.53623 -4133 4 40.6586 5.20983 20.9254 2.90807 4.2574 9.49937 -4134 6 35.8334 28.4358 39.8978 -29.6544 -30.7382 0.627816 -4135 4 35.064 27.7738 39.8775 30.8234 30.4338 1.60118 -4136 4 36.4992 28.0138 39.3349 2.0747 -0.608826 -0.916217 -4137 6 26.5626 3.56604 2.67563 -12.8067 -1.70274 -2.52813 -4138 4 26.0244 3.493 1.8476 6.72613 8.7381 24.6483 -4139 4 26.0719 4.09981 3.36162 5.66066 -13.1585 -23.5937 -4140 6 2.95645 21.6514 17.6824 -3.82104 6.40043 0.291571 -4141 4 2.91294 22.1823 18.4797 -6.37673 0.600795 10.7096 -4142 4 3.68258 22.033 17.1814 1.62588 2.51689 -6.09233 -4143 6 12.886 25.0591 25.9256 19.9254 19.7817 -8.37483 -4144 4 13.3104 25.904 25.618 -13.2675 -16.998 3.60223 -4145 4 12.0452 24.9678 25.4656 -4.65807 1.85418 -5.64346 -4146 6 41.5793 20.6554 14.1751 9.92193 3.46069 0.25892 -4147 4 42.3122 20.2044 13.7523 0.767115 -12.7084 -7.64783 -4148 4 41.9959 21.4893 14.4245 -8.84771 2.34114 1.73285 -4149 6 1.24495 39.6039 11.5378 16.0363 -42.6363 3.17437 -4150 4 1.64626 38.7705 11.134 -18.3255 36.4754 4.46196 -4151 4 1.41802 39.4632 12.4909 -5.9615 12.3362 -8.98123 -4152 6 16.0218 39.0109 34.0619 -0.331369 12.6721 -5.4452 -4153 4 15.5475 38.1996 33.7806 5.75571 19.7523 -4.5346 -4154 4 15.9899 39.7855 33.4251 -7.29137 -28.599 9.21448 -4155 6 20.567 7.02475 25.5588 2.3848 7.82756 -0.6535 -4156 4 20.909 7.86076 25.1782 -7.45606 -9.2474 3.61042 -4157 4 19.6275 6.99553 25.3185 5.42042 5.25175 -3.5088 -4158 6 45.1928 25.5902 39.1787 -21.925 2.17874 18.9559 -4159 4 45.8631 26.0435 38.6892 20.8233 13.1115 -15.3132 -4160 4 45.3324 24.6675 39.0115 4.42968 -17.7425 -2.36405 -4161 6 19.9342 40.1138 28.2835 12.5964 -14.0671 -7.25792 -4162 4 19.0067 40.1593 28.0096 1.46425 5.68018 7.52545 -4163 4 20.128 40.8224 28.917 -7.48392 0.334406 -3.99949 -4164 6 26.4878 14.2069 27.3684 6.98603 -7.23951 -28.1548 -4165 4 25.5412 14.1932 27.2537 -20.7302 0.754551 -2.34698 -4166 4 26.606 14.4537 28.2745 0.836708 4.29804 26.5652 -4167 6 51.3489 25.9487 3.45136 10.7849 20.7191 -13.686 -4168 4 51.0453 25.2386 4.01334 -1.8549 -15.8565 1.21982 -4169 4 51.853 25.5737 2.69356 -6.32678 0.0553236 13.0587 -4170 6 20.1633 26.1247 2.67289 8.83438 -16.1267 5.68002 -4171 4 20.5345 25.2411 2.88723 -1.43181 13.9101 -1.64203 -4172 4 19.9438 26.1088 1.72974 -0.778515 0.427063 3.21599 -4173 6 3.13549 11.9681 27.2232 16.3616 22.3682 9.86323 -4174 4 2.68005 12.663 26.7181 4.92926 -3.58697 -0.471129 -4175 4 3.70389 12.4466 27.8862 -15.0224 -10.9098 -14.9284 -4176 6 30.1793 26.3687 4.00051 28.7119 -30.2966 58.1206 -4177 4 30.7801 25.8341 3.46925 -1.584 2.83444 -17.1702 -4178 4 29.6371 26.9341 3.51662 -25.563 30.6813 -37.7958 -4179 6 19.3205 20.6733 30.5441 -31.721 -6.25106 8.6959 -4180 4 19.1895 21.5008 31.0287 11.509 1.10551 -1.6952 -4181 4 20.2026 20.5869 30.2 22.6938 9.52703 -0.947482 -4182 6 13.5381 36.2475 0.344803 0.685356 24.2985 -17.2657 -4183 4 13.9232 37.1122 0.0997808 14.0363 -10.2996 17.9143 -4184 4 12.867 36.2368 41.5779 -17.3214 -19.7281 -1.62589 -4185 6 13.6931 21.7661 35.9637 -11.3229 -11.9655 -19.5688 -4186 4 13.4645 21.416 35.0694 1.68887 6.71419 14.5774 -4187 4 14.5559 22.1488 35.8465 12.3178 6.48213 0.887249 -4188 6 39.4176 1.76287 25.342 34.0854 -16.9064 9.57103 -4189 4 40.0026 2.33061 25.8435 -14.6367 28.4588 7.32056 -4190 4 40.0689 1.04185 25.2643 -19.5027 -7.65211 -10.5764 -4191 6 18.2964 6.13492 35.8264 -1.82227 -5.92686 -23.3299 -4192 4 18.1639 5.26767 36.254 2.04199 12.8657 6.45456 -4193 4 18.4232 6.85005 36.4651 0.375802 -9.94466 7.47089 -4194 6 2.53148 24.639 10.0969 -49.4669 34.6161 -0.50772 -4195 4 3.3243 24.1433 10.0889 43.7683 -7.59463 9.24933 -4196 4 2.65209 25.5465 10.4987 14.0059 -27.2835 -7.72375 -4197 6 35.8204 9.94567 1.34298 17.6587 14.9905 11.506 -4198 4 36.311 10.4135 0.64327 -4.10869 -3.12473 7.53129 -4199 4 36.1923 10.315 2.19711 -13.0886 -16.0695 -26.9686 -4200 6 29.0171 17.933 41.5847 -7.4648 10.4738 41.1296 -4201 4 28.4325 17.2741 41.1888 4.90819 -0.226834 -17.309 -4202 4 29.634 18.3354 40.9804 6.59061 1.40283 -25.0927 -4203 6 46.0097 27.0807 25.8707 -17.7195 2.90801 -6.40423 -4204 4 46.7639 26.9189 26.4445 5.86789 -6.79057 7.62258 -4205 4 45.3727 26.3443 25.9794 8.73043 2.74283 1.98831 -4206 6 28.1087 10.6569 35.9055 -15.3417 -26.5964 -30.9314 -4207 4 27.3182 11.0018 35.4375 11.5227 2.30745 10.116 -4208 4 28.4572 11.2922 36.5111 4.26863 23.9808 15.1461 -4209 6 25.95 20.1976 24.7821 3.31321 9.63686 -4.79579 -4210 4 26.7637 20.7132 24.6155 -9.40037 -7.04512 10.7501 -4211 4 25.7749 20.1865 25.7378 6.19451 4.49283 1.81458 -4212 6 32.2481 30.2487 10.2005 -0.567171 -33.888 25.4585 -4213 4 32.5217 30.8918 9.54162 14.407 -2.03846 -6.18424 -4214 4 32.9483 29.5597 10.4163 -8.30199 27.6945 -16.8968 -4215 6 5.04696 34.3919 23.8165 18.9071 9.10073 -2.65681 -4216 4 5.8517 34.9395 23.7378 -5.43375 -12.4066 7.00495 -4217 4 4.47737 34.8578 23.2154 -15.6684 -1.23826 -5.97721 -4218 6 29.6446 34.9396 23.1073 8.37026 13.2143 1.46186 -4219 4 30.146 35.227 23.8877 -4.79805 -2.96005 -2.8646 -4220 4 29.6355 33.9874 23.1398 -0.169507 -13.2925 4.62646 -4221 6 52.2021 25.2197 36.2484 0.203165 -13.9358 18.8619 -4222 4 51.9199 25.3821 37.1814 5.20177 -0.668093 -22.6011 -4223 4 52.2823 24.2449 36.2046 0.468647 8.20491 -0.432122 -4224 6 6.9564 41.2598 14.9786 17.963 -12.3423 -19.5336 -4225 4 7.05881 41.0384 15.8913 -5.14113 -1.34859 16.0369 -4226 4 7.66895 40.7276 14.5577 -14.5347 12.9973 2.09466 -4227 6 27.6566 39.1405 4.67566 -15.1179 -12.1251 22.0677 -4228 4 26.8424 38.6352 4.89635 10.0979 9.09612 -9.05456 -4229 4 28.2356 39.0161 5.44259 -0.0995191 -2.46215 -4.35417 -4230 6 44.4488 15.8848 30.3925 -17.4686 4.63448 -32.2897 -4231 4 43.6243 16.41 30.3099 13.0937 -10.0294 9.08699 -4232 4 44.649 15.6212 29.457 1.77951 4.94888 23.2191 -4233 6 27.3024 38.1054 13.0907 0.224949 -17.5042 -4.12929 -4234 4 27.6483 37.328 12.5833 -5.61487 10.2238 13.6353 -4235 4 27.1416 37.8221 14.0243 3.20236 0.189733 -16.1751 -4236 6 26.6663 32.9851 36.8362 -23.8807 -10.2072 10.655 -4237 4 27.4028 33.4987 36.5569 24.2269 11.6336 -10.1628 -4238 4 26.2735 33.5165 37.5295 -1.35435 2.25064 8.62378 -4239 6 26.3226 28.1988 31.7158 32.4613 11.5871 5.04411 -4240 4 26.7492 28.3346 30.8217 -6.54697 -0.873531 32.5908 -4241 4 26.9302 28.5068 32.4691 -17.7353 -8.90623 -33.5497 -4242 6 49.2114 35.7792 23.3295 1.46842 19.8344 9.76806 -4243 4 49.8184 36.2235 23.9243 -3.28067 3.63886 4.6357 -4244 4 49.746 35.0988 22.9506 10.5329 -22.9043 -16.5919 -4245 6 44.2369 15.3613 33.5367 -0.695853 -9.37614 14.4104 -4246 4 44.9539 15.1613 32.9326 3.59625 1.2978 -8.28609 -4247 4 43.6189 15.9562 33.0977 0.720121 5.36694 -8.04858 -4248 6 16.6517 35.2697 14.032 -14.9609 -5.91625 -15.8105 -4249 4 16.8478 36.086 14.4923 5.97715 10.4369 8.21626 -4250 4 15.7311 35.3947 13.7134 15.021 -1.16653 5.16189 -4251 6 45.2991 21.4701 12.0564 -47.5016 11.1637 19.3857 -4252 4 45.9844 21.105 11.5386 20.9258 -26.0087 -22.2564 -4253 4 44.5936 20.7913 12.2178 25.8967 12.3347 -6.55717 -4254 6 51.6438 5.33792 20.1099 7.42219 12.4384 36.9688 -4255 4 51.7517 5.79258 20.9932 -2.42789 -17.2577 -23.3969 -4256 4 50.9203 5.81642 19.7 -6.55397 4.36408 -6.3714 -4257 6 22.6153 27.305 0.955308 -12.5158 1.22245 6.52354 -4258 4 21.8819 27.8542 1.31405 9.62632 -7.19502 -8.89748 -4259 4 23.0385 27.8458 0.276527 0.370713 4.24399 -0.0338259 -4260 6 46.8868 12.1467 22.3289 10.3551 9.03073 -1.70047 -4261 4 46.473 12.5446 21.5671 -2.12653 7.07083 -14.4911 -4262 4 46.1639 11.6922 22.7348 -15.0603 -15.1984 17.3736 -4263 6 33.7555 5.60359 25.2366 8.41588 -11.9289 0.48427 -4264 4 34.4013 5.10188 24.7086 -2.4022 4.68399 3.96997 -4265 4 33.0757 5.86414 24.6127 -5.93503 4.46215 -0.558809 -4266 6 44.2476 18.1243 27.2334 30.0322 17.9475 -5.65933 -4267 4 44.0927 18.7931 26.5253 0.465456 -9.97561 17.2792 -4268 4 45.207 18.2464 27.4768 -29.0014 -6.50023 -5.41996 -4269 6 5.27814 37.006 29.0846 -42.995 37.8911 -11.235 -4270 4 4.83357 37.8684 28.7516 22.264 -36.721 16.075 -4271 4 6.19253 37.2033 29.2507 20.6764 5.54169 3.86921 -4272 6 20.033 5.01392 38.9409 6.34377 -32.2179 -4.45843 -4273 4 19.8009 5.56625 39.6765 -4.47316 13.7366 14.9565 -4274 4 20.2948 4.14306 39.3359 -6.8578 18.535 -7.22498 -4275 6 17.9112 2.77214 33.8677 -16.6976 6.01838 23.4157 -4276 4 18.6113 3.34266 33.5322 6.18073 5.31505 -2.96417 -4277 4 17.3526 3.28629 34.5246 17.6921 -17.568 -20.3177 -4278 6 5.56788 23.3774 22.3326 -7.55986 13.5725 18.1102 -4279 4 6.25354 23.3408 21.6412 1.32241 8.57002 8.68476 -4280 4 5.72116 24.1623 22.9232 3.31135 -14.4794 -19.5174 -4281 6 12.7438 28.0244 40.0809 14.6998 26.4392 -25.8726 -4282 4 12.8099 29.0023 40.1455 -0.120572 -14.3051 2.54846 -4283 4 13.1526 27.8611 39.1965 -9.74214 -4.86635 20.6942 -4284 6 50.5283 38.8014 28.4207 -10.7676 14.1923 -1.71082 -4285 4 51.0354 39.5212 28.0559 20.7423 0.788408 -10.014 -4286 4 49.7626 39.3052 28.7255 -7.2831 -13.6434 5.52883 -4287 6 33.5501 8.21498 17.8605 -32.9279 -35.4008 39.405 -4288 4 33.9027 8.87262 17.3189 24.9798 40.0041 -36.6225 -4289 4 33.9074 7.37462 17.5752 8.43731 -7.27798 -4.46199 -4290 6 34.6457 34.7004 17.7764 -12.4293 -15.9601 -10.9704 -4291 4 35.1223 35.3606 18.2944 6.48769 -0.751965 0.253856 -4292 4 35.2388 33.9528 17.5616 -1.14344 9.31979 5.2604 -4293 6 40.7233 5.29016 23.4005 8.26322 -6.33781 10.3585 -4294 4 41.4774 4.87923 23.8731 -9.49225 7.91527 -13.3731 -4295 4 40.0307 4.6112 23.3711 2.34129 5.18948 -0.0201455 -4296 6 16.9127 27.7621 14.4682 52.6044 -4.68653 -2.89351 -4297 4 16.0711 28.1345 14.4444 -59.8378 16.6137 -1.60006 -4298 4 17.4608 28.5627 14.561 1.7801 -9.46587 0.070581 -4299 6 29.0363 14.6633 5.00698 9.76413 -9.29226 13.7719 -4300 4 29.5096 13.8001 4.93115 -9.10936 16.1071 1.03458 -4301 4 28.802 14.7746 5.95339 2.50956 -1.40994 -14.9204 -4302 6 36.8445 17.7203 5.07362 13.6951 -24.032 -28.6565 -4303 4 36.3003 18.4061 5.45056 -9.17068 14.5835 0.43155 -4304 4 36.9783 17.8862 4.10178 -4.81067 2.65881 25.6667 -4305 6 27.7152 25.5071 34.8558 20.6182 -10.3116 10.9196 -4306 4 28.4128 25.1948 35.4689 -8.51497 -1.72528 -14.7569 -4307 4 27.3626 26.2325 35.3632 -10.8781 12.0961 2.58089 -4308 6 24.7577 17.2803 18.064 -3.70908 -2.75228 5.17573 -4309 4 25.2464 17.9619 18.5343 4.21458 5.85634 1.04617 -4310 4 24.0216 17.073 18.6635 3.98676 -0.349172 -5.54229 -4311 6 30.1887 1.57939 5.82314 -15.3902 21.7461 -57.8894 -4312 4 29.5204 1.81013 6.46928 0.301846 -2.58557 7.21893 -4313 4 29.8355 2.03332 4.95505 20.4457 -28.7719 49.9963 -4314 6 37.4518 25.9014 8.44867 -40.4019 -33.5071 29.4213 -4315 4 38.3881 25.8301 8.67833 5.27698 -2.9507 2.74989 -4316 4 36.9261 25.2192 9.0364 31.48 35.4073 -33.2345 -4317 6 24.7717 7.01585 2.25321 22.1725 6.13312 -2.42992 -4318 4 25.3573 6.36243 2.67285 -8.4103 6.94319 2.38151 -4319 4 23.8861 6.6751 2.35128 -10.8992 -4.25211 1.65182 -4320 6 25.7992 38.8457 10.7505 7.22571 37.8744 -16.0906 -4321 4 26.2906 38.615 11.5103 14.31 -23.6918 34.358 -4322 4 26.1189 39.766 10.6411 -14.7913 -5.88601 -10.6141 -4323 6 0.557249 13.5851 28.1314 4.10373 25.7622 10.4527 -4324 4 0.335523 12.7734 27.7191 -4.86664 -22.4284 -15.6315 -4325 4 0.332586 13.4422 29.0593 -0.0574933 0.663208 0.855409 -4326 6 20.4027 17.1068 12.0342 -11.148 -26.8285 -23.5414 -4327 4 20.2541 17.2545 12.9674 -4.18463 -1.09026 14.619 -4328 4 19.9228 16.2663 11.7843 12.058 20.2306 8.20324 -4329 6 30.9875 7.38585 16.6706 43.1327 18.1844 -1.13431 -4330 4 31.2844 7.10043 15.7746 -9.95685 2.73348 15.1831 -4331 4 31.8198 7.8213 17.056 -34.7561 -19.1709 -8.28734 -4332 6 10.1956 5.78615 12.1691 19.1166 9.414 40.461 -4333 4 10.1305 6.30649 11.4071 -1.6074 30.0602 -42.5686 -4334 4 9.61456 5.08708 11.9844 -30.6818 -38.1141 -6.43609 -4335 6 18.4382 31.3444 24.1606 1.21336 -6.12525 2.83497 -4336 4 18.3965 30.3858 24.3134 -0.788465 1.61506 0.642095 -4337 4 18.2608 31.7571 25.0112 -0.825834 1.26386 0.0223154 -4338 6 27.8905 29.2615 29.2809 39.8074 15.5588 -29.008 -4339 4 28.4007 29.5348 28.4528 -32.3375 -5.53357 22.8869 -4340 4 28.6323 28.9656 29.8273 -8.8667 -4.73078 13.1255 -4341 6 38.3648 15.4483 29.7818 29.0993 -31.9427 29.9284 -4342 4 38.2401 14.49 30.0972 1.05022 38.774 -16.5136 -4343 4 39.2299 15.7257 30.2111 -34.0699 1.82394 -15.2271 -4344 6 21.7074 34.7851 5.58078 8.19375 -39.9271 5.99876 -4345 4 21.4944 33.8203 5.80476 0.548141 38.153 -5.97617 -4346 4 20.9458 35.3238 5.82701 -5.25279 -7.50871 2.73382 -4347 6 18.2117 16.8293 1.01571 -12.7233 9.06437 9.63769 -4348 4 17.5846 17.1799 0.363518 5.67247 -6.87112 -0.25098 -4349 4 17.8106 17.1001 1.86952 7.78128 -5.5379 -6.7416 -4350 6 43.5131 18.5098 39.3469 22.8992 -24.809 -24.744 -4351 4 42.9473 19.1501 39.756 -14.025 22.4758 -1.21679 -4352 4 43.733 18.7829 38.41 -14.2449 3.90475 27.8798 -4353 6 17.7973 10.0724 35.5497 11.3899 1.25644 -17.5776 -4354 4 17.9076 9.35875 36.1674 -1.9111 -9.85084 12.7139 -4355 4 18.4727 9.8826 34.8661 -11.1758 5.45367 7.50841 -4356 6 36.5836 30.5676 29.0795 -26.735 36.4018 -15.4516 -4357 4 36.5101 31.4618 28.6208 1.83791 -30.0083 14.6126 -4358 4 37.4767 30.2665 28.9506 20.8385 -5.81304 -4.31186 -4359 6 38.5024 35.9654 10.4302 15.5283 7.61871 55.4477 -4360 4 38.713 36.6589 11.1463 -7.3207 -22.805 -33.4203 -4361 4 38.3781 35.1576 10.9824 1.19538 10.4075 -12.7486 -4362 6 43.3976 18.7941 34.3717 -4.38817 -12.2014 30.3889 -4363 4 43.0627 18.1963 33.6763 0.988603 1.53223 14.3474 -4364 4 43.2603 18.4022 35.293 0.0857578 9.32555 -37.8245 -4365 6 11.0576 40.22 6.11206 -6.0837 -9.04747 -4.15047 -4366 4 11.6426 40.8981 6.46389 1.08734 7.77423 2.35531 -4367 4 10.1474 40.5638 6.06331 9.30243 4.06404 0.87098 -4368 6 48.3282 13.7431 24.4718 -8.87905 25.3224 16.0087 -4369 4 47.8536 13.4091 23.7195 -8.5266 -8.47545 -16.9724 -4370 4 47.8942 14.6072 24.6749 14.3726 -19.4181 -2.72093 -4371 6 1.47819 25.7805 23.7819 -0.0731812 -13.4431 -3.72387 -4372 4 0.822875 26.4404 23.4927 11.4147 5.84295 7.97453 -4373 4 2.19403 26.202 24.2849 -5.19934 9.21725 -1.17005 -4374 6 20.5754 0.0393205 21.1081 25.6075 5.05031 -17.3956 -4375 4 19.8484 0.361847 21.622 -17.4675 -5.38456 12.9096 -4376 4 20.5586 40.9849 21.0455 -11.1839 1.66381 7.6849 -4377 6 37.6642 12.8991 30.7037 -9.9457 -20.8438 -29.8221 -4378 4 37.1371 12.462 29.9889 18.2914 6.1257 8.16018 -4379 4 36.9745 13.1334 31.2979 -14.5618 11.4049 21.409 -4380 6 49.47 17.3794 9.25364 5.30826 8.19981 -9.14457 -4381 4 48.5231 17.6061 9.31556 15.6584 -1.48937 -5.70503 -4382 4 49.8852 17.9254 8.53549 -14.9109 -12.0851 17.4703 -4383 6 34.3662 5.35535 17.144 13.1974 2.57034 -29.0571 -4384 4 34.5198 5.2998 16.166 0.54303 4.43319 20.4174 -4385 4 33.4623 5.07036 17.243 -16.3394 -6.24992 8.38082 -4386 6 14.7833 27.6665 0.0728061 -6.74966 -7.64198 -7.69033 -4387 4 13.9925 27.8402 41.4242 12.1928 3.48747 9.75107 -4388 4 15.1668 28.5017 0.401621 -7.96817 -0.0208253 -5.02821 -4389 6 48.8656 15.5206 20.7458 -9.86138 0.136748 20.6241 -4390 4 49.0651 16.3952 20.4263 0.209458 6.72405 -7.85333 -4391 4 49.1204 14.8922 20.0789 6.79298 -9.16117 -16.8166 -4392 6 23.807 40.3882 20.3905 -3.398 23.5063 24.1729 -4393 4 23.5208 41.0259 21.1064 9.42377 -19.8715 -22.5683 -4394 4 24.7282 40.1652 20.6096 -6.91059 4.34471 -3.10789 -4395 6 35.1847 31.5046 13.7021 -31.0181 23.9456 -35.1619 -4396 4 34.2309 31.3725 13.4471 24.927 2.88592 7.27171 -4397 4 35.3946 30.8036 14.2945 4.95161 -20.634 19.3451 -4398 6 10.9658 9.01332 39.5058 -15.2714 21.9147 -18.395 -4399 4 10.5965 9.92979 39.4 9.97221 -25.6919 2.69722 -4400 4 11.1763 8.90125 40.4322 -2.36933 4.41176 3.08643 -4401 6 53.2091 4.88966 16.6226 -14.1926 -12.3632 -40.3028 -4402 4 53.7513 5.3458 17.242 7.58091 5.46958 35.753 -4403 4 52.4727 4.38631 17.0042 6.19997 4.37068 9.30068 -4404 6 7.84194 33.803 26.1542 28.433 15.6582 -32.2535 -4405 4 7.6241 34.0763 27.0539 6.31302 8.01731 -0.629847 -4406 4 8.43319 34.4994 25.6777 -29.4311 -29.3345 32.8186 -4407 6 31.3263 27.9445 6.27534 4.23256 -31.0286 -11.1959 -4408 4 31.9071 27.4889 6.92578 -8.71467 11.4818 -6.48617 -4409 4 31.157 27.2952 5.54778 3.06851 13.2477 11.4148 -4410 6 31.3665 2.16522 41.0549 8.67281 8.84877 18.675 -4411 4 31.764 2.22522 0.0553479 -13.0589 -8.62932 -24.7178 -4412 4 31.1679 1.24258 40.8683 -0.324156 -6.15668 4.61941 -4413 6 33.7659 4.25511 35.8987 -17.0312 -3.82062 1.06926 -4414 4 34.343 3.86214 36.5812 -9.75418 2.24627 -3.55813 -4415 4 32.8029 4.08293 36.1352 33.1171 1.27305 -1.46623 -4416 6 47.9658 16.0637 29.8469 2.67107 -7.93457 21.4822 -4417 4 48.7643 16.2814 30.3583 0.589987 0.219824 -12.8585 -4418 4 47.4335 15.6159 30.5321 -1.60863 4.8928 -15.0046 -4419 6 49.3312 10.0914 28.5924 -0.28152 -2.80953 -5.35856 -4420 4 48.5695 10.6519 28.8218 4.15282 -2.34898 -5.74021 -4421 4 49.4995 10.1231 27.6243 -2.44246 2.9592 14.5426 -4422 6 21.4058 27.7857 29.7524 8.26148 -8.5709 13.934 -4423 4 21.8935 27.2574 30.4222 -7.07544 0.199766 -18.4014 -4424 4 21.2999 28.6278 30.1835 -3.48366 18.9655 1.67033 -4425 6 11.6744 39.4982 25.8468 7.90293 7.18169 -2.58674 -4426 4 12.2285 38.7361 26.0681 1.40058 3.92388 1.36909 -4427 4 10.8023 39.1241 25.7384 -12.6269 0.672841 -0.990747 -4428 6 22.9696 39.3076 7.85132 -6.07512 -3.4122 -1.68244 -4429 4 22.2682 38.6524 7.98148 0.173976 5.86283 1.52023 -4430 4 22.7132 40.0561 8.41581 1.67877 -3.24138 -2.90234 -4431 6 42.551 35.9177 31.3369 11.821 -63.1978 11.5341 -4432 4 42.5803 35.466 30.4647 -4.4966 22.226 11.3725 -4433 4 42.4036 36.8376 31.2573 -6.84366 36.9754 -14.9488 -4434 6 33.6582 14.7374 3.97797 20.0935 -7.17859 -40.4554 -4435 4 32.8645 15.2412 4.10613 -20.5582 11.3796 6.05129 -4436 4 33.8494 14.8388 2.99484 -4.26498 -3.76663 30.6135 -4437 6 36.6985 8.59579 17.521 17.5186 -20.4505 -17.8166 -4438 4 37.2174 8.05238 16.87 -10.1577 15.2162 18.3492 -4439 4 36.2061 9.2161 16.9727 -6.85471 3.87096 1.58869 -4440 6 20.8134 32.4132 17.3224 -0.15138 -19.2041 8.32641 -4441 4 20.2101 33.0681 16.9297 -8.31182 -6.81981 10.9196 -4442 4 20.3788 31.7527 17.9441 5.10322 26.2393 -19.6477 -4443 6 20.7088 35.3183 14.0957 -11.7768 -25.3725 -13.8548 -4444 4 21.261 35.5893 13.3574 6.77827 9.37653 -4.07387 -4445 4 20.8679 35.9028 14.8214 6.04206 13.2639 9.85712 -4446 6 20.2377 2.51389 40.1721 -7.12285 -8.41588 24.6249 -4447 4 19.7963 2.31331 41.0421 14.3479 1.04867 -24.2175 -4448 4 20.7189 1.71371 39.9103 -4.456 1.41042 1.49289 -4449 6 15.0332 14.4679 0.20602 13.2809 -6.14192 -34.7112 -4450 4 15.5535 13.6508 41.8516 -13.9549 30.8146 5.37449 -4451 4 15.3124 15.2392 41.5458 -1.11857 -25.4589 11.3055 -4452 6 24.8198 37.3334 18.5262 -9.71694 12.1129 21.4379 -4453 4 24.5044 38.0178 17.9266 6.55828 0.975012 -4.85481 -4454 4 24.4839 37.6255 19.4009 7.37292 -12.3795 -13.3571 -4455 6 3.16023 27.7824 5.25746 -7.59771 -9.49442 8.09122 -4456 4 2.57386 27.9573 6.05068 26.7372 -11.3185 -11.6141 -4457 4 4.04718 27.3724 5.4685 -26.4098 5.90831 3.92345 -4458 6 37.1274 39.059 36.0582 -20.0626 39.3499 3.12364 -4459 4 37.4397 39.697 36.7497 0.155645 -22.9334 -11.3782 -4460 4 37.5741 38.2261 36.1006 18.9616 -13.4483 8.05827 -4461 6 41.3496 16.372 3.85306 -8.55617 -26.9153 -3.74777 -4462 4 41.2863 17.3336 3.84263 10.0449 1.9656 13.5452 -4463 4 42.0245 15.9886 4.46176 -7.16622 24.1057 -6.4954 -4464 6 15.5715 3.1806 35.3543 4.49903 -8.79025 -44.1337 -4465 4 15.0747 3.51322 34.5661 7.45265 -4.29831 20.3405 -4466 4 15.2394 3.62675 36.1076 -11.9729 17.6287 21.2524 -4467 6 33.1697 24.252 7.98021 17.4163 -35.2043 24.5175 -4468 4 33.373 24.4892 7.07941 -5.88693 14.0606 -13.9779 -4469 4 32.5854 24.8767 8.38373 -10.6809 23.5743 -3.02942 -4470 6 35.8792 29.7453 15.5891 -14.351 2.75051 -7.10357 -4471 4 36.7674 29.6271 15.8378 44.9858 5.9786 2.16229 -4472 4 35.4705 29.0828 16.1298 -19.5083 -3.35284 8.18061 -4473 6 17.5951 36.8258 41.8642 -13.8657 0.640745 -39.4401 -4474 4 18.0986 36.7885 0.752491 19.5286 0.61142 14.8967 -4475 4 18.204 36.9888 41.0995 -4.16013 -2.78766 23.3657 -4476 6 26.5622 4.14757 31.1303 -11.2209 -47.8968 -15.8259 -4477 4 27.2883 4.63526 31.456 28.856 27.2634 11.544 -4478 4 26.9475 3.23966 30.9928 -12.9924 23.1667 5.46977 -4479 6 31.9456 1.33308 34.4467 -12.9904 6.64728 -11.4505 -4480 4 32.8071 1.19449 34.8725 -11.0783 -3.65615 8.33208 -4481 4 31.1956 1.0725 35.0172 18.2758 0.413953 2.527 -4482 6 24.503 14.7492 2.38048 9.24208 -0.0712211 -0.802907 -4483 4 24.1928 14.0003 2.93847 14.4388 11.7071 -7.35684 -4484 4 25.4689 14.9243 2.53228 -19.8697 -9.93034 3.69906 -4485 6 25.7634 20.9148 27.525 0.946636 -0.977661 -1.30084 -4486 4 25.4997 20.5428 28.395 3.38508 9.32598 -11.7317 -4487 4 25.6529 21.8806 27.5755 0.284497 -3.23384 4.14496 -4488 6 18.1477 40.1511 30.6505 2.638 -12.7558 5.82509 -4489 4 18.5379 39.2542 30.773 0.361891 20.0487 -3.45439 -4490 4 18.8736 40.7943 30.5754 -0.793328 -5.73314 0.616918 -4491 6 46.8137 23.9108 24.5765 -6.45001 25.2139 -38.2053 -4492 4 46.156 24.4917 24.0674 25.2521 -23.4518 17.6745 -4493 4 47.3533 23.4819 23.8873 -7.92808 3.44465 4.72259 -4494 6 45.5993 22.6806 26.5072 -4.87261 3.12825 -8.14378 -4495 4 46.0946 22.9584 25.7273 -3.42504 -3.72677 5.16847 -4496 4 46.0209 23.1613 27.2227 -5.79148 -3.32105 5.25932 -4497 6 20.0977 4.47574 26.7104 -1.85738 36.2438 14.3308 -4498 4 20.3766 5.37803 26.4593 -10.8474 -9.08605 12.6513 -4499 4 20.6066 3.98633 26.1049 14.7704 -34.5311 -24.6657 -4500 6 35.268 26.6035 12.5547 25.3434 4.5593 25.1203 -4501 4 35.7054 25.7374 12.5354 -13.4481 2.49909 -6.64065 -4502 4 35.8431 27.0669 13.1929 -15.092 1.56141 -12.9558 -4503 6 3.25549 33.9664 12.2985 -21.2488 -6.99508 3.93395 -4504 4 2.30606 33.7392 12.3085 7.5225 -4.25393 -1.25154 -4505 4 3.25844 34.917 12.332 8.53638 16.5693 1.24934 -4506 6 36.6808 1.27299 25.5856 -28.051 -2.86161 17.5249 -4507 4 37.6164 1.46673 25.6835 8.21338 5.71919 3.59986 -4508 4 36.1703 1.6124 26.3685 15.6278 -2.9361 -18.4357 -4509 6 16.8737 4.664 24.0353 -31.9925 -2.01789 -27.2632 -4510 4 15.8786 4.73848 23.8401 40.5517 -2.65221 8.73903 -4511 4 17.2589 4.19458 23.2519 -3.48506 7.68373 17.7614 -4512 6 39.6701 15.0742 7.83356 -1.71206 -7.05123 2.14494 -4513 4 39.2725 14.2274 8.02711 2.44544 -9.24519 17.4119 -4514 4 39.3892 15.1326 6.9218 7.69265 14.011 -7.76766 -4515 6 9.96731 20.1909 2.92864 -13.1382 1.0323 -16.144 -4516 4 9.71565 20.5309 2.05786 3.65664 7.03968 6.64426 -4517 4 9.8995 19.2377 2.78093 4.24026 5.10291 12.3576 -4518 6 23.4077 4.6159 15.27 -3.48308 -16.1533 -1.5067 -4519 4 23.619 4.71624 14.3536 6.29203 -7.01184 -22.1313 -4520 4 23.1672 5.50294 15.4683 -4.33935 19.8524 20.6561 -4521 6 23.5267 41.6518 17.9122 -9.44104 0.807914 21.3506 -4522 4 23.7067 41.2659 18.7956 7.59245 -0.294373 -11.029 -4523 4 22.6339 0.0834245 18.0732 1.82991 3.48892 -13.1537 -4524 6 30.9316 4.82324 1.33107 45.9774 51.3713 7.99935 -4525 4 30.5768 4.02682 1.05687 -28.0042 -54.4029 -17.3695 -4526 4 31.8094 4.8761 0.879215 -15.6392 -0.833181 8.5221 -4527 6 29.2201 33.7587 18.5991 58.073 2.92721 -1.85527 -4528 4 30.1837 34.1183 18.6008 -42.2538 -17.2347 0.0641557 -4529 4 28.6837 34.5413 18.5643 -15.6262 17.5996 3.33909 -4530 6 23.1221 16.7099 3.68521 11.8431 -16.3115 0.0733348 -4531 4 23.6562 16.338 2.95547 -9.45134 2.67217 9.8165 -4532 4 23.048 17.6538 3.54099 -2.31098 6.59774 -1.54538 -4533 6 34.8961 26.7639 31.7325 -1.99602 4.46994 3.67284 -4534 4 35.0929 27.7139 31.562 -2.18198 -17.8875 -5.58085 -4535 4 35.0252 26.2302 30.9312 2.47742 18.1005 -1.54363 -4536 6 7.11189 40.7663 20.959 14.901 4.90705 15.7674 -4537 4 6.49418 40.4573 20.3006 -5.17655 -2.88906 -15.6427 -4538 4 7.9749 40.9101 20.5297 -6.61986 -3.78335 -7.15935 -4539 6 52.4451 9.69387 11.9379 -8.46192 -13.0679 -16.1645 -4540 4 52.1167 8.90553 11.4509 5.46474 18.3719 13.4625 -4541 4 53.1134 10.0871 11.3593 -6.16158 -0.354597 4.80602 -4542 6 12.0344 32.7576 27.7445 1.28323 7.36678 12.5499 -4543 4 11.2848 32.2741 27.3627 7.37999 2.33687 -5.47139 -4544 4 12.7987 32.654 27.1746 -1.40521 -5.62475 -4.84597 -4545 6 15.7821 18.5441 0.84801 8.76354 -4.35468 -11.8188 -4546 4 16.4439 18.9467 1.42581 -3.0166 1.81121 1.10538 -4547 4 14.9492 18.5892 1.29924 -12.8156 0.756803 9.02992 -4548 6 30.9925 13.9418 7.42386 -4.40747 -9.92517 -19.1249 -4549 4 31.0137 13.4754 6.53341 6.38174 17.9129 28.0089 -4550 4 31.6996 14.6103 7.52177 -5.32565 -11.3142 -7.68087 -4551 6 23.9405 39.5605 3.5435 10.8606 -6.43074 -8.73391 -4552 4 24.3095 38.7805 4.04208 -2.00396 18.4511 -18.0645 -4553 4 24.6123 39.8651 2.88148 -9.69774 -9.50421 15.8523 -4554 6 53.2462 13.9551 2.00337 -15.5118 -12.0942 -3.71099 -4555 4 54.104 14.269 2.28215 12.5804 5.35006 1.30654 -4556 4 53.0522 14.3304 1.13281 7.32968 -0.777694 2.32044 -4557 6 29.4483 26.4268 7.81741 -0.171572 11.4439 -18.4732 -4558 4 29.8672 26.7876 7.00927 -3.33338 -4.99995 18.6366 -4559 4 28.5088 26.3872 7.58736 -4.03891 -2.78124 5.15679 -4560 6 24.6251 23.6043 31.0935 -26.8137 17.7603 -44.4691 -4561 4 23.7139 23.2229 30.9355 29.773 11.0738 8.78977 -4562 4 24.7983 24.2076 30.2965 -2.98074 -30.8217 36.523 -4563 6 33.658 19.3188 40.511 -4.29932 4.0975 7.85681 -4564 4 33.8365 18.6271 41.1728 0.0947513 0.993086 -5.72158 -4565 4 34.3002 19.2334 39.7953 0.390848 -1.03282 -3.03706 -4566 6 0.558986 35.9852 14.2205 11.1667 11.0015 21.0521 -4567 4 1.21386 36.1432 14.9149 3.92292 -5.96876 -2.97707 -4568 4 0.043734 36.7876 14.3014 -15.3768 6.08493 -10.5247 -4569 6 7.05222 12.7587 15.7802 -26.1824 -15.4106 14.8382 -4570 4 6.35773 12.5373 16.4499 19.2033 7.53925 -13.5919 -4571 4 6.88557 12.0803 15.1093 4.12905 5.75416 0.888 -4572 6 7.8802 3.87979 22.4264 4.564 -30.6165 13.1651 -4573 4 7.61737 4.55637 21.8154 -5.12813 13.4305 -13.5146 -4574 4 7.59435 3.01808 22.0419 3.92228 16.9329 8.71162 -4575 6 50.747 32.0919 16.246 0.584829 29.9532 -6.88448 -4576 4 49.8575 31.8158 16.477 -3.66132 0.0213613 -0.234359 -4577 4 50.6533 33.048 15.9617 2.92819 -31.696 10.1835 -4578 6 15.3083 18.2099 30.0577 17.4273 -12.3999 25.5818 -4579 4 14.8795 18.523 29.2753 -13.2188 2.60124 -19.4058 -4580 4 14.9888 17.3027 30.2404 2.47215 8.3937 -6.40515 -4581 6 36.7253 25.4508 33.3862 -30.1432 30.6395 -17.6873 -4582 4 35.9871 25.9696 32.8546 42.334 -36.2451 27.5582 -4583 4 36.7428 24.5171 33.143 -7.68133 1.91065 -3.3758 -4584 6 16.5208 21.8449 20.262 -11.2097 8.64672 -3.63533 -4585 4 16.6085 20.9267 19.9682 1.68058 -0.497742 -2.90804 -4586 4 16.3112 22.3946 19.4823 4.36577 -8.59001 6.07269 -4587 6 44.2833 3.11948 30.0766 -7.99673 -6.73576 30.9987 -4588 4 44.2005 2.2232 29.7402 -0.794022 -7.70278 -4.62871 -4589 4 44.5183 3.67066 29.3503 7.77568 15.2131 -24.9404 -4590 6 51.0808 14.1269 27.7758 -27.047 -14.2895 -4.28411 -4591 4 51.175 15.071 27.7901 8.66575 19.7266 0.878182 -4592 4 50.1173 14.0309 27.5969 15.0189 -4.76366 3.10402 -4593 6 54.1497 15.8755 27.1203 10.9044 -5.07506 15.753 -4594 4 54.6247 15.0341 27.411 -19.35 18.5916 -21.6107 -4595 4 53.6213 15.8397 26.2863 11.6919 -13.2292 13.7718 -4596 6 26.7269 15.1716 34.5247 3.07047 6.28357 -2.56105 -4597 4 26.6547 16.15 34.5201 9.87746 -16.6036 -4.19036 -4598 4 27.4477 14.9176 33.917 -5.54963 13.4877 1.89491 -4599 6 34.6713 2.21044 27.481 35.3652 -9.42756 14.1603 -4600 4 34.3712 2.0217 28.3795 -9.10436 3.38048 -0.887416 -4601 4 33.9282 2.37922 26.9258 -24.4077 6.67858 -6.22498 -4602 6 36.3012 17.6491 40.388 5.86113 23.4658 6.44349 -4603 4 35.7206 17.1804 39.7974 -3.43874 -12.7236 -2.47465 -4604 4 36.6864 17.0408 41.0377 -6.22241 -0.114851 -7.42509 -4605 6 26.2819 0.194243 33.0916 -21.1162 -1.74839 5.89968 -4606 4 26.0541 0.792538 33.818 7.17118 8.51167 2.05738 -4607 4 25.4361 41.6393 33.0097 0.772233 -7.73624 -3.23605 -4608 6 5.19547 35.5715 31.6247 14.6733 -21.492 26.4929 -4609 4 6.10271 35.831 31.8735 -9.75028 2.17691 -1.53344 -4610 4 4.97694 36.0548 30.8519 -3.41417 18.4244 -29.6169 -4611 6 20.2195 22.0294 35.119 8.25657 -3.203 11.321 -4612 4 19.9286 21.1888 34.7559 -2.68712 -4.78598 1.15285 -4613 4 20.5567 21.7901 36.0152 -5.29706 4.10974 -20.8318 -4614 6 15.9087 36.5843 36.9399 0.69981 -30.9087 31.3945 -4615 4 16.5764 37.2836 37.0377 -3.33596 -3.14632 -1.27145 -4616 4 16.032 35.9777 37.754 -5.87689 21.7482 -34.0408 -4617 6 30.95 22.3912 3.57027 12.227 -51.3484 -20.5494 -4618 4 31.0645 22.6091 4.4902 1.82476 2.59415 19.1922 -4619 4 31.2691 21.4218 3.50648 -13.7255 40.3499 2.75328 -4620 6 47.0405 8.41049 14.2025 -7.26712 -13.7585 -23.7685 -4621 4 46.2225 8.31623 13.6472 18.9804 2.55096 13.7682 -4622 4 47.7321 7.85584 13.7597 -18.0416 11.4216 8.02226 -4623 6 34.1106 18.627 3.15563 -0.4946 23.1394 22.2065 -4624 4 34.672 18.2914 3.86301 0.996255 -3.71784 -4.49801 -4625 4 34.2399 18.1173 2.36738 0.542984 -13.2578 -17.3669 -4626 6 26.7976 25.3916 12.343 -23.6037 -44.5624 17.4882 -4627 4 27.2059 26.2338 12.4335 13.1462 29.8808 4.32264 -4628 4 26.6887 24.995 13.243 7.37483 11.5945 -21.6739 -4629 6 22.6215 25.7777 30.8835 17.9212 -8.3502 11.6983 -4630 4 23.3826 25.7056 31.4928 -6.70991 6.16838 -4.71983 -4631 4 22.2455 24.8881 30.8847 -4.10822 -0.13742 -3.2228 -4632 6 23.6315 9.78689 35.7599 5.48292 -2.30097 -0.625566 -4633 4 22.8113 10.2893 35.7248 -4.77612 1.7474 -0.383276 -4634 4 23.3643 8.87406 35.5171 2.31753 16.9109 3.97959 -4635 6 10.4044 36.7742 9.63922 -25.0741 -4.1625 3.51028 -4636 4 9.48479 36.4361 9.55892 17.1497 7.1291 1.06445 -4637 4 10.7029 36.9295 8.73946 3.49181 4.27039 -8.54773 -4638 6 4.00239 32.4234 25.8687 17.3833 10.7639 11.9139 -4639 4 4.35688 32.9952 25.1699 -1.7627 -0.965582 -1.95819 -4640 4 3.3252 31.8731 25.4905 -12.2764 -14.2405 -10.2138 -4641 6 29.0717 26.0252 18.6551 27.2015 -27.7815 2.54409 -4642 4 28.1485 25.9947 18.9226 -9.28828 -8.18845 2.68073 -4643 4 29.5616 25.1801 18.9271 -24.0321 31.3207 -7.4501 -4644 6 15.3034 1.33037 27.9713 -8.15532 13.2931 -1.88459 -4645 4 14.9824 0.900448 27.1643 -4.10476 8.37726 9.18093 -4646 4 14.8435 2.19317 28.1161 8.64797 -17.4448 -9.70896 -4647 6 48.6122 2.88813 22.9601 -14.0575 20.6462 10.9468 -4648 4 48.3097 2.01316 22.7294 4.97712 -8.72373 -1.92059 -4649 4 49.4728 3.0448 22.5739 5.56154 -9.57595 -10.4155 -4650 6 53.0134 0.348391 19.7218 2.72624 -2.60203 -3.14968 -4651 4 52.5877 42.0257 20.5538 -0.625041 0.289898 3.74318 -4652 4 52.305 0.305612 19.0628 -0.905041 -0.864478 -1.55308 -4653 6 1.39118 17.4858 17.9447 -8.50794 14.6458 12.7327 -4654 4 1.24353 17.4779 16.9894 -1.31782 -10.0732 -1.96873 -4655 4 1.47925 16.6123 18.3551 -1.8326 -9.29856 -10.4725 -4656 6 37.8975 19.0277 37.6053 -28.6618 15.029 -11.7184 -4657 4 36.9647 18.7897 37.7838 11.6122 1.96204 1.16191 -4658 4 38.4406 18.4447 38.1174 10.3965 -16.3488 12.6679 -4659 6 26.9855 30.3558 38.071 9.50079 1.40194 -4.36533 -4660 4 26.0886 30.216 37.7369 5.39533 7.19535 -1.12484 -4661 4 27.2954 31.2276 37.7499 -13.0308 -11.5285 -0.168161 -4662 6 20.0885 18.5747 3.04679 -6.02291 21.5949 -15.2672 -4663 4 19.9787 17.7407 3.50085 7.53739 -11.7285 12.3408 -4664 4 20.8981 19.0299 3.33477 -4.38138 -14.9723 0.744253 -4665 6 35.0861 6.94018 4.08702 3.04221 -3.62035 -0.583554 -4666 4 35.6351 7.18342 3.33325 6.4301 -2.1748 -2.62446 -4667 4 34.2564 7.39563 3.93984 -10.6534 0.652929 2.2495 -4668 6 22.2213 37.08 31.2556 -28.1532 13.1327 42.6182 -4669 4 22.1563 36.8958 30.3458 -2.68084 -5.78815 -35.014 -4670 4 21.2899 37.3194 31.5407 35.2494 -6.03647 -12.8067 -4671 6 12.3954 22.364 41.8234 21.4337 26.9075 -8.21443 -4672 4 12.9612 23.1595 41.5956 -22.2624 -27.6618 12.5485 -4673 4 11.7092 22.295 41.1522 0.74395 2.83494 0.343647 -4674 6 43.2331 30.3213 23.157 26.8689 32.5799 1.85734 -4675 4 44.1495 30.0558 22.8796 -21.7207 5.89602 6.32158 -4676 4 43.3514 31.2801 23.4416 -6.45211 -30.9956 -6.78246 -4677 6 16.5257 8.07813 16.6617 -19.4309 -12.5216 11.6481 -4678 4 16.3886 8.34983 15.7476 7.00958 2.01583 -5.14722 -4679 4 17.4107 8.32004 16.9428 8.9294 8.4681 -2.86418 -4680 6 10.0506 8.65043 31.7756 -2.39508 10.2278 -10.4865 -4681 4 10.14 7.97578 32.4103 1.95442 -36.8206 12.1998 -4682 4 10.116 9.39125 32.3649 -0.107045 27.388 0.472024 -4683 6 10.1509 6.49695 25.6483 14.6726 -6.33183 2.00995 -4684 4 9.37694 6.15153 26.0805 -12.3653 -8.75157 5.1154 -4685 4 9.82248 7.1865 25.0601 3.70088 -0.958502 2.30736 -4686 6 49.8668 7.2369 25.5225 -24.0329 9.97804 -6.35029 -4687 4 50.053 6.31696 25.3599 8.14544 -13.6468 -2.92498 -4688 4 50.6696 7.6642 25.7982 18.0374 4.82749 5.17198 -4689 6 18.4641 37.5693 33.932 -1.74635 9.46172 -1.89257 -4690 4 17.7617 38.2474 34.0853 10.1616 -18.2299 -3.47398 -4691 4 18.0542 36.6946 34.0238 -8.30855 4.53024 1.19921 -4692 6 32.1897 34.7964 39.2558 32.2313 -17.5381 13.0656 -4693 4 32.48 34.3381 40.0896 -7.23509 10.7133 -18.5379 -4694 4 31.2879 35.0284 39.3813 -31.6037 5.0658 8.82 -4695 6 49.5304 23.9104 4.45569 25.8701 3.67026 -38.321 -4696 4 49.7808 23.1947 5.01942 4.2809 -18.8946 17.0996 -4697 4 48.8132 24.3493 4.85794 -31.8244 16.1567 21.064 -4698 6 6.0606 24.4992 33.9345 -0.638471 -2.64646 7.7036 -4699 4 6.7001 23.7849 33.7997 2.17947 5.97399 -8.00372 -4700 4 5.47521 24.1274 34.6146 -0.567039 8.82042 -5.77933 -4701 6 1.71497 22.9937 24.1827 2.23241 21.1509 -1.27791 -4702 4 1.62302 23.9425 23.95 -0.486435 -10.8617 3.92094 -4703 4 0.825214 22.7289 24.4403 -5.44701 -4.12175 2.39318 -4704 6 12.4657 16.5565 32.3481 -44.3953 42.3465 -23.9812 -4705 4 13.2256 16.0186 32.4214 25.6927 -27.9273 24.4997 -4706 4 11.8347 16.6394 33.1026 23.5286 -12.3088 -0.369419 -4707 6 21.3722 37.3857 27.9432 8.33623 1.67622 30.3175 -4708 4 21.2745 37.3852 27.0022 -8.47587 6.30229 -26.1478 -4709 4 20.7646 38.0573 28.2974 0.343549 -1.37388 -6.67046 -4710 6 27.2371 40.835 28.8059 -14.5618 2.70883 26.0148 -4711 4 26.5104 41.4636 28.9519 7.17104 -1.72995 -14.6333 -4712 4 27.2442 40.3637 29.6524 5.83721 -3.62297 -8.28664 -4713 6 0.999535 21.7321 13.5318 -29.3194 4.17708 -0.571391 -4714 4 1.85706 21.6318 13.8745 50.1621 -4.04822 5.83187 -4715 4 0.493313 21.4968 14.3164 -12.4374 2.61082 -2.41507 -4716 6 22.3196 2.57547 8.74609 19.5097 -5.43411 17.7027 -4717 4 22.9517 3.10624 8.26305 13.4452 6.72454 -0.92593 -4718 4 21.5477 2.63817 8.2102 -22.9662 -0.14239 -10.9727 -4719 6 29.9886 17.8486 8.24374 -1.93571 4.49032 -2.67939 -4720 4 29.0601 17.6146 8.32603 -5.42798 -1.41354 1.1127 -4721 4 30.4131 17.4547 9.01282 4.29332 -3.23535 5.29369 -4722 6 3.62824 37.7086 25.7053 -21.3362 8.32154 -6.60892 -4723 4 4.42904 37.184 25.8405 -4.94962 -9.47676 -0.42012 -4724 4 2.83762 37.1591 25.4673 21.6133 3.65171 5.88982 -4725 6 26.7972 27.6476 36.3581 -47.4115 -5.5291 12.7506 -4726 4 26.8465 28.2624 35.6306 8.29087 8.74477 -10.4705 -4727 4 25.8218 27.6191 36.6005 30.1762 -0.597939 -6.56813 -4728 6 13.3509 25.3111 38.1214 6.90903 -15.9492 13.2692 -4729 4 13.3459 24.3911 38.4732 0.919555 17.3618 -5.73458 -4730 4 14.144 25.7168 38.5298 -8.43807 -1.25323 -5.48633 -4731 6 49.7161 27.2636 6.73274 -18.8339 5.2299 -32.7408 -4732 4 49.5935 26.3653 6.40806 5.58405 -0.645115 8.82912 -4733 4 49.2001 27.7791 6.04852 15.3529 -4.94049 26.886 -4734 6 39.7451 11.5811 10.2076 8.75523 -9.51322 -11.6408 -4735 4 40.371 10.9447 9.80262 -5.32314 14.1891 9.76509 -4736 4 39.1233 11.799 9.49079 2.50191 2.43793 7.76023 -4737 6 17.4883 24.9894 35.5591 -19.4762 1.01983 7.35275 -4738 4 17.0975 24.7887 34.694 2.72786 0.423626 1.28381 -4739 4 18.4353 24.8575 35.5073 10.004 -2.92602 -7.93295 -4740 6 45.0832 34.9807 31.8277 24.5651 -3.79623 6.38158 -4741 4 44.3095 35.5111 32.0501 -8.6141 -4.27399 -12.5931 -4742 4 44.9123 34.3632 31.1055 -12.5508 0.508806 -0.453023 -4743 6 30.2187 9.89463 31.3271 7.05348 4.55507 6.68413 -4744 4 30.4541 10.7656 30.9635 -3.12777 -8.04008 8.45875 -4745 4 30.1355 10.0083 32.293 1.90576 1.32601 -8.54322 -4746 6 32.3712 9.2149 6.61373 28.8381 -35.7198 -39.9492 -4747 4 32.1726 8.66567 5.78496 5.01502 20.0116 29.9298 -4748 4 31.5547 9.49954 6.96481 -36.3246 12.521 14.22 -4749 6 9.26959 24.9556 35.9161 1.96832 15.842 -17.2096 -4750 4 8.91298 25.4858 35.1726 -0.127744 -15.1166 11.0351 -4751 4 9.85583 25.5957 36.3463 -2.24606 -10.0757 2.02076 -4752 6 40.3298 1.49261 18.8755 10.6299 1.30292 -21.7 -4753 4 39.6194 1.80532 19.3944 -35.8146 17.5344 12.5449 -4754 4 40.7796 0.936194 19.4956 21.1502 -18.4862 6.40423 -4755 6 5.26901 10.6323 30.4328 -1.07618 -0.575959 25.8078 -4756 4 5.0059 11.4532 29.9824 1.00544 3.53991 6.4134 -4757 4 5.36238 10.8297 31.4225 -4.75078 2.46468 -31.0333 -4758 6 25.6472 11.7043 25.6564 -2.85241 -30.912 5.54365 -4759 4 25.9319 12.4737 26.1319 5.23872 14.1859 6.15637 -4760 4 25.9893 10.9537 26.204 -5.41829 19.961 -14.7301 -4761 6 21.91 20.0664 29.7913 -6.2328 1.4725 0.460556 -4762 4 22.5319 20.0532 30.5545 -13.0709 -9.05965 -9.53591 -4763 4 21.5487 19.1817 29.5606 11.8355 8.09924 7.60661 -4764 6 10.008 19.9919 34.5046 11.2891 -12.0839 -11.2138 -4765 4 9.40296 20.4589 35.0806 -5.60052 -0.834193 8.04722 -4766 4 10.0208 19.0442 34.745 -1.06298 11.667 -2.12072 -4767 6 24.6334 10.3662 12.209 5.25257 18.8662 20.0118 -4768 4 24.6941 9.47775 12.5956 1.57271 8.96717 -2.9517 -4769 4 24.9719 11.0034 12.9045 -11.2568 -27.0384 -15.8586 -4770 6 50.4496 28.283 11.5446 48.5969 7.21476 -25.6728 -4771 4 51.3012 28.7385 11.2434 -32.0883 -19.6524 11.3949 -4772 4 50.1145 28.8771 12.2081 -10.2548 6.02908 11.3498 -4773 6 13.9159 27.6234 25.0588 -25.6331 11.4059 -15.4978 -4774 4 13.5005 28.0493 25.83 5.93925 -3.01588 -8.8098 -4775 4 13.4276 28.0022 24.2718 14.6036 -12.4854 23.8457 -4776 6 46.1589 18.6653 40.4078 -23.2184 -0.389309 -10.7846 -4777 4 45.2349 18.5626 40.0761 15.1795 0.391647 5.46432 -4778 4 46.2048 19.5984 40.6658 -0.558864 -5.77386 -4.91212 -4779 6 32.4746 14.176 27.1227 -16.003 2.1806 5.505 -4780 4 31.9042 13.6172 27.6867 7.52463 5.83279 -7.70325 -4781 4 32.1655 15.0897 27.2802 4.78128 -6.53963 -2.41902 -4782 6 14.0556 36.3553 13.3828 19.8073 6.5728 22.6139 -4783 4 14.1017 37.3298 13.5875 -14.1879 -23.5484 -13.1576 -4784 4 13.3212 36.1206 12.8052 -8.41953 14.8686 -5.40295 -4785 6 1.88392 36.5802 21.9963 -4.52806 -9.18778 1.34501 -4786 4 1.78058 36.5165 22.9531 -3.13652 -1.22736 7.08711 -4787 4 2.81062 36.8013 21.8509 3.08344 1.49572 -0.20158 -4788 6 25.283 31.8665 39.7486 -0.0346121 -4.3463 21.3102 -4789 4 24.9491 32.7147 39.4474 -1.97702 6.83441 1.95234 -4790 4 25.5262 31.9404 40.7015 -5.12155 2.92558 -20.0537 -4791 6 6.47988 22.0137 1.28428 -12.6715 -7.61279 -4.66874 -4792 4 5.53909 21.8738 1.48571 10.6555 3.73696 2.93659 -4793 4 6.5727 22.8978 0.916948 1.0061 5.37498 -0.183021 -4794 6 27.6236 25.0404 4.70626 6.00578 18.2896 15.2827 -4795 4 28.5331 25.4118 4.61276 -17.9968 -6.47987 4.19831 -4796 4 27.2352 25.3966 5.54825 13.7859 -6.49357 -18.8943 -4797 6 21.6401 30.9371 41.2305 6.69834 21.9548 -27.1087 -4798 4 21.276 30.3289 41.855 -17.7491 -18.0709 13.8774 -4799 4 21.0024 31.0127 40.4783 8.64888 -5.56942 17.5854 -4800 6 32.355 18.8729 12.7674 13.4209 4.31066 2.75957 -4801 4 31.3956 18.9706 12.835 4.55688 -5.10905 -10.5867 -4802 4 32.607 18.5493 11.8826 -7.53687 3.28724 6.30822 -4803 6 35.6452 19.4617 21.1556 -9.82604 19.2175 8.60555 -4804 4 35.3405 18.5718 21.3708 -2.26659 -3.59924 -3.4629 -4805 4 34.936 20.0876 21.4701 16.8427 -19.1907 -7.36791 -4806 6 27.6904 17.9595 34.0135 2.51947 12.848 9.8691 -4807 4 28.1207 18.371 33.2456 -3.55582 0.0466306 5.59907 -4808 4 28.0719 18.4525 34.7708 -4.77519 -7.99763 -12.3529 -4809 6 34.1913 39.0308 14.8198 -32.2909 7.81486 42.3772 -4810 4 33.7378 38.3849 14.2709 2.40292 -0.641653 -5.60016 -4811 4 33.4938 39.1934 15.5434 31.6198 -1.67931 -26.5413 -4812 6 28.5078 3.47132 33.888 -4.80695 9.04662 2.15546 -4813 4 27.9441 4.2497 33.8725 -11.1427 -2.20885 -1.07295 -4814 4 29.3801 3.85895 33.8332 18.6007 -6.2612 -1.20104 -4815 6 34.9259 32.1312 6.54177 -41.0464 -12.9808 21.9467 -4816 4 34.0171 32.0297 6.98271 38.7419 4.2921 -24.6555 -4817 4 35.5211 32.1736 7.29951 5.76537 -1.35874 -3.25655 -4818 6 31.8896 6.8799 23.5232 0.89208 3.44668 5.58958 -4819 4 32.4231 6.58347 22.7679 -0.16899 1.4285 3.8543 -4820 4 32.2407 7.75715 23.7826 1.29066 -6.24882 -6.25814 -4821 6 18.8559 1.76458 0.828337 -20.5472 23.3683 -17.7838 -4822 4 18.0266 2.11952 0.42761 13.2396 -12.575 3.84382 -4823 4 19.0445 2.38904 1.53279 3.18086 -1.81057 9.578 -4824 6 26.9929 18.9294 11.856 68.8676 -4.65359 -28.5611 -4825 4 27.3133 19.7685 11.4551 -15.5879 -7.28987 7.59546 -4826 4 26.1136 18.988 12.1267 -55.7646 13.8464 15.3945 -4827 6 43.8351 11.1458 18.4443 23.0031 -19.5153 4.50837 -4828 4 43.638 10.8812 17.5537 -13.1544 4.18059 -17.1583 -4829 4 44.5589 10.5175 18.6246 -1.75483 13.9327 9.72942 -4830 6 33.4946 40.5615 37.6755 15.4013 8.76106 -9.33396 -4831 4 34.0096 40.2689 38.4502 -12.4229 -1.46966 -1.83753 -4832 4 32.5786 40.2698 37.7667 -1.95229 -4.85928 9.55413 -4833 6 15.6186 26.7023 39.419 -29.2453 -49.1617 7.39509 -4834 4 15.4971 26.9949 40.3155 1.17426 12.5786 14.7177 -4835 4 16.1446 27.3092 38.9602 29.5915 33.502 -22.8309 -4836 6 4.38071 13.8775 40.883 9.27553 -14.126 -4.37485 -4837 4 5.31782 13.6454 41.0342 -11.8393 4.50398 0.960258 -4838 4 4.04834 13.2497 40.2173 2.13772 10.7877 7.68198 -4839 6 20.1656 10.4005 38.218 10.8779 4.82467 -13.4554 -4840 4 20.4848 10.7245 37.3555 -10.2589 -5.36296 0.708096 -4841 4 20.9923 10.2607 38.6798 -1.28838 -2.71386 11.844 -4842 6 15.1666 19.24 23.8849 4.49083 -8.21488 3.46045 -4843 4 15.3253 20.1347 24.2296 -1.0797 -1.90309 -4.08137 -4844 4 15.0239 19.3391 22.9299 0.969961 5.53483 11.956 -4845 6 47.8934 28.614 15.7995 12.3109 16.1315 8.54118 -4846 4 47.9523 27.7003 15.5425 0.10403 -15.196 -3.00888 -4847 4 48.6265 28.752 16.4246 -6.57835 -5.21115 -6.70139 -4848 6 29.9259 30.9075 18.965 7.62461 4.23841 -1.37457 -4849 4 29.1117 30.4308 18.7732 -7.06282 -5.88302 -2.4339 -4850 4 29.7134 31.8391 18.8515 -2.57834 1.4724 1.74445 -4851 6 11.9338 35.8178 28.497 -7.27451 6.14295 -10.3733 -4852 4 12.5041 35.9802 29.2427 6.70347 11.4983 16.16 -4853 4 12.1847 34.9375 28.2428 -3.53576 -18.0038 -9.26428 -4854 6 29.972 37.8772 25.486 -12.1052 4.73031 -22.3992 -4855 4 30.2553 36.9663 25.6711 3.40868 8.54106 4.83275 -4856 4 30.3747 38.5051 26.0898 8.03536 -1.45294 10.6494 -4857 6 52.6584 28.1048 32.275 31.4311 4.91254 4.04956 -4858 4 52.2473 28.8547 31.8392 -9.38068 2.35947 -3.12986 -4859 4 53.5924 28.4001 32.3224 -6.05351 -9.99886 1.81474 -4860 6 37.0156 40.0823 11.982 15.2095 -8.99172 -8.52195 -4861 4 36.22 40.5624 12.1833 -15.2617 4.79593 6.40041 -4862 4 37.4101 39.8767 12.8402 0.665617 -0.484924 4.09883 -4863 6 16.6662 16.7824 36.4899 -23.6543 20.4081 -13.3107 -4864 4 16.0299 17.4889 36.7962 20.061 -22.8424 -10.9222 -4865 4 16.728 16.9177 35.5139 -3.3638 -0.555369 18.7216 -4866 6 27.9984 4.17668 38.8431 -6.8633 -1.77316 4.22536 -4867 4 28.9161 4.3061 39.1095 4.06977 1.67187 2.70396 -4868 4 28.0368 3.69267 38.0106 -3.95018 -5.40445 -5.6405 -4869 6 28.9057 0.266004 17.7212 -6.10073 29.2375 -5.44551 -4870 4 28.1786 0.88303 17.5246 8.92385 1.95552 -1.67076 -4871 4 28.4447 41.3635 17.8399 -11.0591 -30.1495 5.35559 -4872 6 22.9291 20.1009 26.2737 12.905 2.01461 18.3128 -4873 4 23.6265 20.0378 26.9508 -1.05622 -6.52034 -10.1156 -4874 4 22.4706 20.8929 26.5742 -3.00423 3.39878 -4.61403 -4875 6 49.3993 29.9017 13.433 -6.38025 27.1117 -0.919919 -4876 4 49.1201 30.8275 13.1802 1.84527 -26.9682 8.98406 -4877 4 48.7504 29.5045 14.041 1.51099 8.43883 -0.914593 -4878 6 2.44855 24.8301 7.30401 -10.5471 2.4163 20.698 -4879 4 2.41495 24.6588 8.2845 -1.1432 9.4633 -23.8545 -4880 4 1.72338 25.455 7.1058 6.30785 -9.44609 7.39061 -4881 6 30.3915 26.4508 14.3344 -6.38639 41.9339 41.7386 -4882 4 31.0669 26.3804 15.0403 -0.162406 -14.5956 -15.076 -4883 4 29.932 27.2875 14.6522 8.5071 -34.3491 -22.1885 -4884 6 27.0361 32.5047 3.13805 -13.013 14.5566 5.91638 -4885 4 26.4776 33.1542 3.63465 13.8957 -14.3888 -12.6314 -4886 4 27.3381 31.8882 3.81715 0.997102 -1.94867 -0.811892 -4887 6 34.2693 14.8073 1.28197 14.9869 -24.9335 -24.2287 -4888 4 35.1732 14.4308 1.1613 -12.3133 12.1546 9.27146 -4889 4 33.7818 14.2606 0.617478 5.51233 18.0169 18.4334 -4890 6 30.0243 8.54272 1.33127 -15.3984 1.11418 15.9731 -4891 4 29.9557 9.47917 1.12547 1.89625 5.05184 -1.94546 -4892 4 29.278 8.4251 1.95594 13.4411 -5.55834 -8.66406 -4893 6 42.5535 11.5155 27.7085 15.437 -3.44919 -13.726 -4894 4 42.3225 12.4337 27.8881 -6.79772 -1.02898 5.45325 -4895 4 41.899 10.9203 28.077 -14.0379 1.06089 7.70623 -4896 6 52.4658 39.5603 17.8381 6.64956 -28.6351 -32.0971 -4897 4 51.7413 39.7621 18.3991 -22.9429 13.2738 25.1291 -4898 4 53.1708 40.1592 17.9962 19.9289 22.995 10.0024 -4899 6 33.211 4.92827 31.629 -12.2211 32.167 9.39859 -4900 4 32.8163 5.83971 31.6275 7.84415 -21.2817 2.59476 -4901 4 32.9135 4.52627 30.8083 -0.68235 -2.18314 -5.10952 -4902 6 6.29493 15.9859 18.7482 13.6791 10.985 9.78561 -4903 4 5.93033 16.6016 19.4273 2.88753 -17.718 -13.1605 -4904 4 5.60754 15.3724 18.4768 -10.6912 0.909102 4.08099 -4905 6 8.51749 14.5386 24.6879 -5.02573 1.07483 -2.93277 -4906 4 9.38168 14.4087 25.0828 4.4136 1.3116 3.34168 -4907 4 8.20169 13.6557 24.4566 1.37146 0.850768 1.15416 -4908 6 22.6856 10.1159 32.1347 3.63858 -5.5341 -7.29103 -4909 4 22.4401 11.0127 32.2731 -27.0162 20.0988 15.0061 -4910 4 23.4682 10.3148 31.6383 25.2173 -15.197 -13.8617 -4911 6 11.2884 2.11431 14.6724 -33.0968 -7.95794 -19.898 -4912 4 10.3134 2.08073 14.4479 21.8664 -1.34414 10.3974 -4913 4 11.7152 2.30811 13.8211 9.70644 2.30495 0.939267 -4914 6 44.9099 15.5878 36.2745 25.7257 2.41581 -13.4012 -4915 4 45.0546 15.5553 35.3019 -10.2235 2.9059 20.3658 -4916 4 43.9848 15.4747 36.4307 -17.7944 -2.84066 -0.111047 -4917 6 9.72168 19.0116 31.2214 10.0341 -21.2505 -12.9994 -4918 4 10.5925 19.389 31.3727 0.996524 0.534629 3.32861 -4919 4 9.08651 19.5363 31.6795 -15.0033 12.5653 12.9482 -4920 6 51.9861 7.59179 16.6767 -2.21949 13.5197 0.492591 -4921 4 52.6037 6.8327 16.6765 -16.3843 6.63384 -16.8766 -4922 4 51.5083 7.75362 15.8118 21.6515 -16.4571 17.7861 -4923 6 31.4364 34.7816 36.4086 3.08769 21.0155 -3.2672 -4924 4 31.7704 34.8477 37.2975 8.82098 -13.2304 13.8104 -4925 4 31.3443 35.7177 36.1951 -3.32863 3.82124 -15.3061 -4926 6 4.22848 15.0876 15.3675 -15.1793 -4.71932 15.5862 -4927 4 4.10446 14.9036 16.3273 5.02277 2.80423 -15.2934 -4928 4 5.16622 15.2495 15.2447 10.6913 1.67801 0.337818 -4929 6 47.7535 20.6847 28.0297 3.73811 3.24498 -1.95167 -4930 4 47.6703 19.7739 27.6852 3.21079 12.9013 3.0329 -4931 4 48.3469 21.1738 27.4217 -9.1514 -8.95746 6.26441 -4932 6 15.7983 1.14885 24.4111 -6.64534 16.957 -16.446 -4933 4 15.3695 0.397874 24.8496 -11.2605 5.13601 -9.62176 -4934 4 15.1572 1.72115 23.8957 14.1067 -25.56 23.4483 -4935 6 34.5718 39.7067 40.0668 -5.06722 14.7699 1.92827 -4936 4 34.1159 40.1215 40.7935 -0.0189783 27.8984 7.01187 -4937 4 34.2456 38.8495 40.221 -5.22714 -44.7262 -10.8544 -4938 6 20.1936 32.176 34.4055 -22.5016 27.7868 41.3602 -4939 4 19.6673 32.7687 35.0502 14.2298 -29.0143 -30.198 -4940 4 21.0584 32.1328 34.8407 -2.28869 -2.39527 -4.5293 -4941 6 19.3074 38.5208 11.8317 17.689 14.4135 -2.63233 -4942 4 19.236 37.5914 12.0232 -0.177798 -10.0936 4.99209 -4943 4 20.0172 38.8749 12.4245 -13.7536 -7.85063 -8.99287 -4944 6 6.52955 13.5023 26.836 -16.6143 37.6784 -17.6139 -4945 4 6.084 14.0762 26.1427 18.8957 -21.2062 24.9102 -4946 4 6.49663 12.6281 26.4634 0.197125 -15.4908 -4.14034 -4947 6 23.5952 31.5638 33.3318 1.16311 -12.5666 -5.83621 -4948 4 23.0836 31.562 34.1475 0.610672 3.97154 0.891929 -4949 4 23.5328 30.6432 33.0053 1.46337 8.27478 -1.79938 -4950 6 41.0778 31.9114 16.1974 16.3032 -14.6541 -18.8682 -4951 4 41.8878 32.072 16.7344 -12.1593 -9.44827 -16.6375 -4952 4 41.2894 31.3264 15.4036 6.53327 16.9697 25.199 -4953 6 31.7476 18.8699 19.3483 9.2825 22.1595 5.37598 -4954 4 32.0642 19.7361 19.7036 -9.20895 -19.367 -8.68372 -4955 4 31.4026 18.3831 20.1168 1.10858 -0.37958 -4.48043 -4956 6 10.4875 4.12209 19.3444 6.70816 11.4672 -10.0773 -4957 4 9.70261 4.48263 18.8666 20.7562 -4.21822 -0.723312 -4958 4 11.3166 4.33216 18.8218 -27.5212 -3.06207 15.0001 -4959 6 1.37991 32.4635 19.2846 24.7257 -29.6508 -15.3303 -4960 4 1.97113 31.6954 19.1311 -3.90248 7.07021 19.3035 -4961 4 1.16609 32.6455 18.3731 -9.24935 13.5936 -9.63824 -4962 6 42.8716 16.8513 24.9892 37.8526 -21.8211 -51.5646 -4963 4 42.4398 17.6894 25.0051 -12.6784 17.6471 3.13223 -4964 4 43.4179 16.871 24.1222 -26.4831 0.994324 39.976 -4965 6 45.3183 19.1979 4.10041 6.37956 15.045 3.35342 -4966 4 46.1127 19.7887 4.04575 -15.2131 -7.48775 2.85843 -4967 4 44.6191 19.6898 4.58798 10.0124 -1.75765 -5.61527 -4968 6 29.1291 19.8804 35.7574 13.154 -41.1853 -12.3735 -4969 4 28.6049 20.2559 36.4387 -19.4183 16.2678 16.1743 -4970 4 29.3151 20.5439 35.0927 -1.78114 11.3903 -2.63997 -4971 6 31.9353 21.8377 19.6787 8.2762 14.7684 -3.54893 -4972 4 32.7301 21.8918 19.0885 -22.5823 -4.29925 15.9785 -4973 4 31.6692 22.7774 19.8195 3.83825 -20.8185 -1.08359 -4974 6 39.1936 8.26228 18.8336 -23.7578 16.4079 -2.4793 -4975 4 38.9784 7.343 18.63 -1.41923 -3.63173 -0.882922 -4976 4 38.3593 8.77699 18.6285 24.7505 -17.6369 4.60834 -4977 6 33.27 13.2649 41.2621 -10.1289 -28.0457 11.6457 -4978 4 32.3532 13.5818 41.1472 2.43324 -1.71459 -0.314725 -4979 4 33.2053 12.355 41.6729 1.3348 20.3333 -9.56947 -4980 6 5.93721 29.5458 35.7995 -7.4397 -15.3695 -5.23966 -4981 4 6.3797 30.3135 36.1022 6.42857 23.5026 12.0451 -4982 4 6.51225 29.246 35.0987 1.02237 -6.8727 -9.18458 -4983 6 13.023 34.1764 31.9266 -10.1581 -4.84889 27.419 -4984 4 13.003 33.3874 31.3637 -4.82745 -5.23795 6.11925 -4985 4 12.6053 33.9771 32.8123 10.4055 -1.49763 -26.3146 -4986 6 33.9757 21.8032 17.9969 16.1152 -19.1834 -4.43927 -4987 4 34.6651 21.0941 18.0436 -13.0194 10.1005 -1.31384 -4988 4 34.4424 22.6001 17.7557 11.611 10.6919 -5.33679 -4989 6 35.9777 41.3398 18.1614 -6.56463 -6.11943 -26.9477 -4990 4 35.8856 41.423 17.1648 6.35377 -3.40276 32.4743 -4991 4 36.5823 0.128109 18.4064 3.22136 6.47441 1.04719 -4992 6 34.856 37.6452 30.5972 -0.647303 3.94572 7.36538 -4993 4 35.2577 36.9607 30.0196 0.445186 1.06156 15.4535 -4994 4 34.8848 37.3986 31.5588 5.49281 -5.52744 -23.9922 -4995 6 25.9972 34.4216 4.68589 -10.7784 -9.94602 -21.2075 -4996 4 25.3582 34.53 5.39473 2.66172 5.48603 12.8385 -4997 4 26.8259 34.8497 4.89674 4.47855 8.12742 13.9663 -4998 6 19.0606 33.5662 1.31783 4.31184 23.0948 -29.5486 -4999 4 19.7493 33.0549 1.74461 7.17592 -5.61608 3.87291 -5000 4 19.5019 34.1007 0.592753 -8.94353 -18.7796 23.9626 -5001 6 25.2721 8.22916 8.60038 8.3672 -6.50911 13.4278 -5002 4 25.4774 8.1828 9.55838 -2.37789 7.03817 -10.0574 -5003 4 25.4001 9.14285 8.30246 -0.229164 -0.61302 1.82749 -5004 6 12.8408 19.6874 13.0432 23.1779 -10.767 -3.57874 -5005 4 11.9236 19.9359 13.0109 -16.1394 8.08564 -1.3752 -5006 4 13.3549 20.4875 12.8299 -11.6819 -5.55115 1.76181 -5007 6 53.3458 11.4322 5.81729 13.7919 -26.0181 10.511 -5008 4 53.941 11.999 6.3288 -5.2171 7.54934 -1.97002 -5009 4 52.6156 11.905 5.44666 -11.025 16.6744 -4.72885 -5010 6 9.84401 16.0447 31.1965 1.52473 25.7097 1.4485 -5011 4 9.0725 15.75 30.7245 -12.2986 -10.5074 -10.4763 -5012 4 9.76401 17.0228 31.1974 4.09395 -10.8484 3.46066 -5013 6 25.4337 20.2897 3.31222 -0.0744965 -16.6885 15.2888 -5014 4 25.4502 20.7681 4.1742 1.29774 3.58896 -22.0188 -5015 4 25.617 20.9088 2.59036 0.892976 4.59184 10.0233 -5016 6 20.7687 8.19442 15.6442 -13.8219 -45.5838 -0.24202 -5017 4 20.3131 8.5145 16.4113 -6.16339 18.6345 13.1662 -5018 4 20.3525 7.29833 15.5772 17.5129 18.5489 -8.91575 -5019 6 37.6537 8.61162 9.99803 6.38032 -10.5281 17.8344 -5020 4 37.9174 7.70722 10.2264 -2.01487 8.44182 4.78342 -5021 4 37.3414 8.51532 9.10193 -3.86116 3.7435 -6.65528 -5022 6 50.6588 4.51187 24.2729 -10.1552 -3.70856 6.87258 -5023 4 49.9071 3.88527 24.1971 13.583 4.61791 0.248303 -5024 4 51.4381 4.036 24.5943 -3.42543 -3.47462 2.6777 -5025 6 20.1632 24.8244 34.8962 -12.0105 28.899 -22.2545 -5026 4 19.9486 25.4522 34.1467 5.29317 -18.0262 19.0072 -5027 4 20.331 23.9626 34.5117 -0.31696 -10.3492 -2.27521 -5028 6 30.5785 22.522 11.2467 -2.76969 13.8933 23.9619 -5029 4 31.2526 22.1243 10.7257 13.2932 -13.8734 -17.1472 -5030 4 31.019 23.338 11.5119 -11.6942 5.7798 2.38886 -5031 6 17.322 40.803 8.03266 14.2969 -15.2802 9.14469 -5032 4 17.3696 39.9923 8.55945 -20.3131 5.85274 7.92005 -5033 4 18.1352 40.6655 7.5489 4.4024 9.10004 -19.1526 -5034 6 23.9661 41.0457 26.0803 21.1205 -0.428792 10.5169 -5035 4 24.3123 40.6207 25.2948 17.4674 -5.32369 -4.96192 -5036 4 23.0464 41.0448 25.8953 -36.0489 4.67224 4.09659 -5037 6 9.79449 25.5813 27.216 11.7002 -20.4303 -20.1428 -5038 4 10.1564 25.0129 26.491 -8.57195 17.3601 17.171 -5039 4 10.1924 25.2359 28.0288 -3.53182 0.239058 0.558234 -5040 6 35.2535 29.8267 24.7533 16.8399 6.514 6.92542 -5041 4 34.3962 29.6585 24.3475 -6.29365 6.70405 -5.90439 -5042 4 35.51 30.7547 24.57 -10.2352 -8.20594 -2.77553 -5043 6 2.14051 4.25227 10.5512 -4.35014 2.09559 7.87868 -5044 4 1.87018 4.24401 11.51 4.03105 2.56783 -22.6964 -5045 4 1.48695 4.75313 10.0317 0.0426026 -1.98947 12.7879 -5046 6 43.1755 3.92129 23.5016 -16.6861 -14.9885 0.818311 -5047 4 43.8939 4.14262 22.9078 7.68421 2.83398 -7.81803 -5048 4 42.5577 3.34913 22.9937 11.3891 7.34243 2.48813 -5049 6 18.8996 22.6297 2.43765 22.7339 -13.1014 -2.24121 -5050 4 19.79 22.181 2.40524 -25.7911 11.1615 4.63986 -5051 4 18.7139 22.8085 3.37028 4.18935 -2.21949 -1.21374 -5052 6 20.4908 18.9405 41.5599 0.284845 -17.4141 21.8797 -5053 4 20.1374 18.6064 0.533469 2.69626 22.1818 -33.2143 -5054 4 19.9839 19.6587 41.147 -4.56676 -6.01516 12.1125 -5055 6 26.4163 7.55623 29.1338 1.47231 -3.25042 -11.8229 -5056 4 25.7099 7.08251 28.6481 8.40182 7.03804 13.9135 -5057 4 27.0821 7.71224 28.4448 -4.02075 -2.1597 11.7889 -5058 6 25.6465 35.5679 33.7595 -11.9902 -19.4032 2.16293 -5059 4 26.3374 36.2384 33.6103 2.60319 -14.9989 -6.30077 -5060 4 25.8315 34.6987 33.2841 2.54327 33.8846 12.2934 -5061 6 24.8333 0.493635 8.41989 34.5336 11.5552 47.2955 -5062 4 25.5249 0.302877 9.1499 -35.8013 6.01564 -39.2036 -5063 4 24.7614 41.6068 7.91956 0.436288 -16.6888 -13.1367 -5064 6 17.008 17.3182 3.45493 -26.2706 15.7324 15.4846 -5065 4 16.2426 17.9829 3.53843 29.8189 -30.5055 4.13684 -5066 4 17.1653 16.9244 4.35506 -11.2277 16.1793 -19.3505 -5067 6 40.1827 32.1035 19.3506 13.0539 -5.95213 0.358733 -5068 4 39.8335 31.2604 19.604 -25.4023 -11.2285 12.0125 -5069 4 40.9513 31.7409 18.9215 18.5667 14.352 -9.19942 -5070 6 23.3808 26.7171 6.31746 29.0762 21.4976 14.3842 -5071 4 24.13 27.3908 6.46801 -30.1018 -19.5893 -7.69607 -5072 4 22.7349 27.0723 5.68536 3.11778 6.18165 -0.6273 -5073 6 28.6527 28.5112 1.41186 -10.6623 -30.4119 4.69741 -5074 4 28.683 29.4458 1.20631 15.125 4.74584 -7.70298 -5075 4 29.5288 28.0803 1.2704 -12.115 26.7011 1.44139 -5076 6 12.0438 6.3157 14.0384 -8.70244 -3.06108 -4.52058 -5077 4 11.2798 6.1721 13.4181 27.4537 -0.215786 8.28745 -5078 4 12.8925 6.19521 13.5554 -16.057 2.9292 1.41242 -5079 6 20.1243 33.7022 32.0954 -30.4257 7.53408 -8.19993 -5080 4 20.1371 33.1054 32.8412 7.6416 -5.80656 10.7415 -5081 4 21.0197 33.8732 31.8382 18.9224 -1.8204 -0.321518 -5082 6 12.0625 33.3632 34.5388 -0.325915 -41.4281 -23.9157 -5083 4 11.5602 33.8727 35.1697 -10.674 0.646784 10.687 -5084 4 11.6234 32.4653 34.3673 14.5179 34.5198 8.14895 -5085 6 6.00279 22.2605 25.0501 2.06163 -11.5991 79.3474 -5086 4 5.88194 22.3996 24.153 -16.4068 14.8809 -57.8418 -5087 4 5.25089 22.6367 25.5854 16.5977 -6.05374 -22.2773 -5088 6 28.8802 9.48792 11.0269 30.0757 -27.8021 5.60101 -5089 4 29.142 10.167 11.6644 -15.2392 1.2069 -12.766 -5090 4 28.0854 9.70897 10.5587 -15.7703 15.13 -3.00542 -5091 6 25.9783 31.1564 24.8742 0.212243 -23.2246 11.0271 -5092 4 26.2703 31.9474 24.4305 5.78101 9.73635 -10.8861 -5093 4 26.5948 30.4205 24.6499 -9.08002 14.2421 1.82694 -5094 6 17.4069 22.6321 26.9528 -11.8732 29.0046 13.506 -5095 4 17.1509 23.4374 27.5137 11.798 -28.7792 -23.9739 -5096 4 17.5283 21.9112 27.5803 0.671776 -8.09241 2.21186 -5097 6 30.9731 17.6144 1.64569 13.582 26.8251 31.1357 -5098 4 30.2123 17.6859 1.07719 -13.0538 -2.75682 -13.3747 -5099 4 31.0067 18.4528 2.19078 1.05257 -25.2161 -14.5596 -5100 6 35.2833 9.73343 11.2271 -16.277 -4.62114 -26.0747 -5101 4 34.627 9.45499 10.5137 29.3374 5.62349 25.4867 -5102 4 36.1567 9.37366 10.9701 -6.28276 0.375521 -3.01301 -5103 6 12.0057 10.8077 4.27601 -12.2512 -1.40581 -7.43609 -5104 4 11.4458 10.5898 5.05281 2.39288 0.24657 -15.6405 -5105 4 11.51 10.5288 3.46435 7.55978 2.35404 20.8087 -5106 6 52.9546 23.1284 7.66438 3.19212 11.9041 -9.13647 -5107 4 53.8155 23.0936 7.22037 1.72331 -6.21969 -0.472682 -5108 4 52.7997 24.0739 7.82392 -0.633169 -8.94194 3.43433 -5109 6 27.374 5.80114 23.1096 7.51778 12.7335 11.6917 -5110 4 28.1753 5.52132 23.6349 -22.415 18.9583 -13.4562 -5111 4 27.3645 6.79042 22.9959 5.3793 -33.2455 5.89418 -5112 6 22.7689 37.6996 15.5372 -5.91943 -7.67105 33.7333 -5113 4 22.8436 37.842 14.6084 2.14719 5.97904 -25.5056 -5114 4 23.2999 36.9284 15.7907 -0.822855 1.46565 -2.93441 -5115 6 30.5901 30.1355 39.7465 -8.92084 9.99629 -19.6672 -5116 4 30.0839 29.6315 39.0953 -1.54922 -9.94816 6.16305 -5117 4 30.5761 31.0154 39.3281 8.00114 -4.73058 9.29019 -5118 6 26.5152 14.8694 29.9646 3.93344 -0.205179 -3.29595 -5119 4 25.7559 15.3094 30.3103 -24.5604 12.1261 -1.41502 -5120 4 27.0839 14.9289 30.718 22.1413 -5.57177 12.178 -5121 6 9.52543 19.5487 37.4182 -4.93509 -3.75546 7.04348 -5122 4 8.56858 19.5373 37.6772 20.7537 10.8584 -9.00922 -5123 4 9.7741 20.4052 37.0166 -14.5013 -9.56436 9.93265 -5124 6 0.91928 14.8658 2.69601 -17.5095 9.99019 63.3715 -5125 4 1.47581 15.1737 2.02419 28.2707 8.36374 -43.6031 -5126 4 1.18821 15.4309 3.47389 -7.04008 -21.0896 -18.5042 -5127 6 46.427 27.1287 41.5945 43.2461 -1.33556 -25.8044 -5128 4 47.402 27.2052 41.2817 -46.4011 -2.64418 15.4668 -5129 4 46.0299 26.5803 40.8989 0.996959 5.24299 8.87294 -5130 6 47.678 23.0562 21.3872 5.44089 38.3346 6.01366 -5131 4 46.9403 23.2179 20.8133 -13.997 9.90145 -6.64011 -5132 4 47.7418 22.1285 21.385 8.56341 -43.7487 4.99103 -5133 6 39.8587 22.235 3.08723 2.37939 -15.5871 -9.21378 -5134 4 39.0088 22.2526 3.53641 -4.44104 7.43329 4.08383 -5135 4 39.9535 21.2857 2.86173 -0.917299 22.2801 6.61021 -5136 6 14.9853 14.9328 33.4647 9.90785 18.6887 5.96998 -5137 4 15.4024 15.8269 33.5858 -13.0369 -24.3412 -0.758701 -5138 4 14.5599 14.6915 34.3048 3.28451 6.61064 -6.43534 -5139 6 27.3302 11.4834 31.9317 -27.4366 -15.9755 21.8219 -5140 4 26.9982 12.0952 32.5883 -9.79098 -5.70708 8.51591 -5141 4 28.0752 11.9422 31.6406 46.9031 18.536 -28.2392 -5142 6 36.7579 7.97089 7.62034 -1.24967 -18.9477 -14.6485 -5143 4 35.954 7.42009 7.70022 6.4697 6.94413 -3.0671 -5144 4 37.4142 7.36122 7.22008 -3.07725 6.9494 1.66736 -5145 6 49.4451 9.66335 18.2174 -4.20907 -17.0946 -5.32386 -5146 4 50.1075 10.0642 17.6138 -11.2883 10.4151 20.0604 -5147 4 49.0937 10.2089 18.9473 16.8995 10.9543 -13.1485 -5148 6 27.0353 33.866 10.7555 -3.61813 20.4819 39.0174 -5149 4 27.1089 33.3944 9.9425 -11.0368 -7.55411 -28.9907 -5150 4 26.1735 34.332 10.8422 4.28798 -12.7598 -13.2634 -5151 6 11.1949 37.4624 6.84871 0.36549 -16.8746 15.3404 -5152 4 10.8648 38.3395 6.66289 0.465253 11.7734 -2.90488 -5153 4 12.1583 37.5341 6.85599 1.64848 0.115814 -1.2743 -5154 6 19.2537 19.4156 21.9114 -15.7985 8.22585 33.6704 -5155 4 18.5515 19.3251 21.2863 -16.3583 -5.26309 -15.3133 -5156 4 20.0646 19.323 21.4355 25.7859 -3.53787 -14.4318 -5157 6 54.4972 2.91444 22.5674 41.6328 11.7794 25.4635 -5158 4 54.323 3.09449 21.6644 -16.7292 4.15243 -34.296 -5159 4 0.405558 3.31869 22.7045 -24.6299 -12.807 4.19326 -5160 6 45.0583 10.8549 24.2301 5.83399 20.0221 21.0618 -5161 4 44.4296 11.5751 24.1426 -7.03973 -3.51443 -9.4179 -5162 4 45.6095 11.2138 24.9523 4.1225 -19.1196 -10.3672 -5163 6 14.387 34.402 24.7643 -0.614961 -5.50567 -8.46915 -5164 4 14.802 35.2302 25.0278 -0.621724 2.17228 4.67692 -5165 4 14.8142 34.1913 23.9221 -0.527667 -3.77388 -2.27373 -5166 6 50.586 17.557 4.30707 17.1275 -18.9627 18.6811 -5167 4 51.3126 17.9927 4.759 8.45418 -3.82203 7.11351 -5168 4 50.1863 18.2804 3.88376 -26.598 27.5468 -24.7799 -5169 6 14.9317 33.3337 34.1113 -12.3404 20.8418 56.9019 -5170 4 15.0455 32.9404 33.2912 5.44957 -23.8922 -53.334 -5171 4 14.0148 33.1563 34.3942 8.12215 6.97131 -5.23034 -5172 6 20.8706 33.5768 38.9143 15.1188 7.04694 -15.6549 -5173 4 20.7999 34.008 39.7578 -2.44584 7.66125 17.1111 -5174 4 20.3826 32.7659 38.9944 -10.1095 -18.4284 -0.973943 -5175 6 7.78494 4.73961 26.7587 18.7098 -5.63937 13.378 -5176 4 7.2181 5.0845 27.4506 -5.7435 6.37459 2.19378 -5177 4 7.246 4.75931 25.9687 -5.82922 -1.99593 -5.70414 -5178 6 9.28281 21.4851 22.3014 51.087 14.0475 -25.6174 -5179 4 8.74732 21.9732 21.6886 -31.0609 5.1079 -5.58489 -5180 4 10.1706 21.7227 21.8793 -22.1752 -18.3044 28.8298 -5181 6 20.5441 38.2146 8.8638 -2.83914 11.917 26.817 -5182 4 20.3663 38.6401 9.7626 4.81036 -21.6973 -30.7816 -5183 4 20.4013 37.2533 8.94236 -1.07384 9.24152 7.62946 -5184 6 30.1053 39.0795 30.7451 -13.6764 41.2724 28.6819 -5185 4 30.3998 39.946 31.2193 -9.10868 -42.8123 -24.766 -5186 4 29.1169 39.0706 30.8728 28.3121 -0.882933 -5.94109 -5187 6 16.0486 22.0268 24.5039 34.2787 3.60452 0.906339 -5188 4 16.7735 22.0671 23.8432 -14.3833 -3.87047 -0.289875 -5189 4 16.5419 22.3002 25.3044 -14.2176 -3.36187 3.5873 -5190 6 5.74232 29.2062 14.4594 -18.34 10.8061 -32.1404 -5191 4 6.48422 28.7094 14.7814 11.5218 -3.49899 17.506 -5192 4 5.24211 29.6259 15.1721 5.10135 -5.91064 9.04276 -5193 6 28.0673 3.08827 25.2267 -6.08854 1.42804 12.0746 -5194 4 28.6661 3.71086 24.7756 -7.19123 -0.840207 10.3279 -5195 4 27.7106 3.5203 26.0449 13.0908 -0.523763 -20.3567 -5196 6 45.9319 29.2971 31.4223 -7.33073 21.7818 28.5056 -5197 4 45.7264 28.738 30.6765 -12.0419 -4.51403 -16.7723 -5198 4 45.1872 29.9464 31.611 20.2512 -24.9239 -13.0948 -5199 6 11.2178 22.8398 36.7928 3.83605 7.6889 -19.1741 -5200 4 10.7288 23.4227 36.1801 1.54849 -6.36416 6.79315 -5201 4 12.0227 22.5824 36.3 -5.92076 -0.954096 11.0422 -5202 6 18.9236 40.1387 39.9284 -8.72712 -15.4473 12.674 -5203 4 19.137 39.1923 39.9727 -1.01676 1.76774 -7.47997 -5204 4 18.926 40.4024 40.8597 -1.95632 5.76083 -1.10583 -5205 6 23.5567 26.0801 21.2876 -20.8354 -5.58511 20.4095 -5206 4 22.8283 26.6117 20.9473 7.44123 1.31497 -7.03875 -5207 4 23.1869 25.6705 22.0991 12.7429 3.57595 -14.6326 -5208 6 16.8309 5.38685 15.8596 17.5735 -24.6285 20.3591 -5209 4 16.4468 5.29371 14.9868 -10.6119 14.9975 -0.930521 -5210 4 16.6163 6.1995 16.3389 -7.69088 7.65746 -13.895 -5211 6 12.049 26.6129 14.9962 1.83385 5.07399 -16.0821 -5212 4 11.6864 25.936 15.5307 6.55853 -24.3886 27.1256 -5213 4 11.2609 26.839 14.5085 -0.894459 16.8406 -16.785 -5214 6 14.3334 41.4222 2.37421 26.0216 21.5484 -18.2857 -5215 4 13.7051 40.9662 2.90199 -22.7144 -12.1023 21.977 -5216 4 14.3738 0.426145 2.71152 -4.41702 -11.6567 2.07407 -5217 6 50.4009 35.8582 9.31454 24.1561 17.2373 -12.1424 -5218 4 50.8168 35.8748 8.42953 -10.1576 -5.67977 3.83986 -5219 4 50.8977 36.5714 9.7704 -11.7974 -14.2445 3.10197 -5220 6 11.3695 22.6672 26.8678 6.20997 3.92483 11.2558 -5221 4 12.2048 22.3333 26.5164 -4.88328 -1.76893 -0.685046 -5222 4 10.6892 22.391 26.2565 -8.40373 -4.36232 -8.95219 -5223 6 8.45148 34.5593 21.2814 -25.9919 -59.0281 13.1791 -5224 4 8.04792 35.0446 21.9998 -0.548909 12.0582 7.93151 -5225 4 8.02348 33.6171 21.3881 27.3669 48.26 -12.6189 -5226 6 9.41918 8.68911 24.4735 -32.1109 22.232 -11.1027 -5227 4 8.45415 8.80658 24.2608 22.5553 -3.45738 3.03744 -5228 4 9.54271 9.26889 25.2379 6.1219 4.18012 4.13063 -5229 6 32.6166 22.3351 34.507 3.90791 9.0503 -27.7323 -5230 4 32.5036 23.1955 34.0662 0.599489 -5.17288 -1.28756 -5231 4 32.8196 22.6091 35.3861 6.87298 3.84758 30.2519 -5232 6 26.7427 26.1702 7.11338 18.0622 8.0778 -11.4877 -5233 4 26.0574 25.7087 7.60312 -9.51312 -3.43645 7.19196 -5234 4 26.4504 27.0916 6.97179 -2.60416 -16.0173 4.37043 -5235 6 33.9976 11.9299 3.97475 -1.16308 1.75568 6.69865 -5236 4 33.7915 11.6388 4.87314 3.4696 4.99202 0.68255 -5237 4 33.8545 12.8906 3.99294 -0.306808 -3.71184 -1.40707 -5238 6 21.4819 20.9256 37.2108 -8.76322 20.972 13.918 -5239 4 22.36 21.3309 37.2026 5.25525 -6.97128 0.105034 -5240 4 21.5739 19.9858 37.0637 7.9716 -15.2147 -3.23728 -5241 6 18.467 41.0278 0.654954 -19.554 -29.5721 -12.8619 -5242 4 17.5024 41.1258 0.530294 8.77033 6.01734 2.0842 -5243 4 18.8042 41.8885 0.845086 4.40915 26.8371 2.49279 -5244 6 41.3548 41.7118 25.1844 12.9409 14.5374 -0.392323 -5245 4 40.9222 40.8883 25.4041 -6.90081 -12.2223 3.22908 -5246 4 41.5202 41.6634 24.2378 -1.56977 -0.361026 -1.444 -5247 6 27.6369 28.1312 3.93858 39.9773 31.9241 -60.8173 -5248 4 27.7577 28.1455 2.91253 -1.05119 3.80663 52.0412 -5249 4 26.945 27.5412 4.09124 -36.8498 -31.9254 8.70709 -5250 6 18.2839 10.5111 31.4966 0.533258 -0.0130678 0.979798 -5251 4 17.4029 10.1636 31.5665 -10.6602 -13.9647 -0.00296819 -5252 4 18.1106 11.4466 31.5267 10.9856 11.4938 1.12981 -5253 6 11.3036 37.9694 14.764 4.77413 -10.0896 11.5971 -5254 4 10.7874 37.239 14.4221 -9.53089 5.23111 -9.63971 -5255 4 11.7579 37.5414 15.5118 -2.30342 16.6377 -5.07599 -5256 6 0.816524 18.1414 27.5647 20.1272 -0.3628 -0.469578 -5257 4 0.17179 17.4415 27.469 -11.396 -5.37013 -1.78049 -5258 4 1.63281 17.6507 27.785 -7.45447 11.2502 -1.88757 -5259 6 36.8008 10.7378 20.295 8.4208 9.86458 8.47872 -5260 4 36.1948 10.0642 20.0001 -9.44027 -8.16387 -5.04241 -5261 4 36.5983 10.8279 21.2363 1.65531 0.40354 2.85938 -5262 6 47.4201 25.5213 8.04394 8.74054 5.57223 -13.14 -5263 4 47.3566 25.6372 7.0634 -2.71671 -4.96685 23.4826 -5264 4 46.5708 25.2582 8.40304 -6.39129 0.734124 -5.55138 -5265 6 13.9238 35.1275 16.0037 32.5083 18.1998 3.59786 -5266 4 13.2022 34.5755 16.1957 -32.489 -30.3694 18.6715 -5267 4 13.7597 35.4303 15.121 4.25156 9.41728 -20.5426 -5268 6 29.562 35.3734 16.1776 -35.0835 -2.07929 -8.00281 -5269 4 30.2224 34.9599 16.7245 13.9673 -5.91711 9.2078 -5270 4 28.7051 34.8863 16.2926 25.5199 12.926 -4.35301 -5271 6 29.4722 25.8866 32.4187 14.354 2.72026 -23.1845 -5272 4 28.9025 25.7608 33.1796 -14.4011 -9.23541 2.43376 -5273 4 29.1922 25.3818 31.6086 -3.9853 6.0929 23.1903 -5274 6 24.1343 2.13601 25.4438 45.8363 12.8335 -27.0328 -5275 4 24.6226 2.81425 24.8647 -23.4035 -21.9591 22.2831 -5276 4 24.7019 1.32842 25.3981 -18.0817 13.4017 1.18969 -5277 6 4.54354 34.4275 19.14 11.1292 -12.0398 21.377 -5278 4 4.4735 34.5954 18.1883 -15.738 1.03246 1.7136 -5279 4 3.71635 34.4131 19.6775 9.89222 2.06937 -18.6971 -5280 6 10.1248 17.2257 14.3121 -1.66581 -5.60367 -9.60454 -5281 4 10.2583 17.5937 15.1679 8.8306 2.43924 21.0325 -5282 4 9.4989 17.8227 13.9164 -6.75609 1.38519 -13.487 -5283 6 21.4392 41.7587 34.6855 22.2624 7.769 -11.2018 -5284 4 21.5032 41.1211 35.405 -13.4071 -7.19641 7.36579 -5285 4 20.544 -0.0182627 34.3462 -4.72666 -12.2957 11.4101 -5286 6 36.1543 24.108 12.5954 -4.82194 -9.49577 -8.67068 -5287 4 35.691 23.694 13.3698 5.25066 1.62288 -23.6525 -5288 4 35.776 23.8018 11.7194 2.97337 4.42231 26.8685 -5289 6 49.5838 18.601 19.9434 7.37368 0.836531 -4.03301 -5290 4 50.0063 19.3607 19.4891 -2.40205 -12.3461 5.19746 -5291 4 50.2865 17.9356 20.0577 -3.44895 8.52353 -2.14521 -5292 6 1.26001 7.05318 14.4907 38.3056 -26.8237 -27.7837 -5293 4 1.8201 6.82299 13.6677 -23.9217 11.4061 34.9177 -5294 4 1.48256 6.35829 15.148 -4.21477 12.5307 -9.57675 -5295 6 12.7431 22.7759 31.2417 -21.5742 -17.6245 -17.2109 -5296 4 12.7068 22.0167 30.6251 -0.189583 12.5272 11.0438 -5297 4 13.6543 23.0267 31.2833 20.8009 4.17698 1.04357 -5298 6 8.18693 18.6259 27.8062 12.2535 -2.56913 -7.18349 -5299 4 8.40416 17.6764 27.919 2.05523 15.8207 -2.89848 -5300 4 8.90605 19.0032 27.258 -7.77238 -10.2714 7.52916 -5301 6 52.132 28.0244 15.3085 -5.0475 -8.46487 8.97907 -5302 4 52.2845 27.4141 14.5747 1.7297 4.34316 -0.517396 -5303 4 52.1194 28.9169 14.9336 2.1814 -6.82244 -4.33507 -5304 6 52.6909 21.916 10.0977 -8.33066 3.09691 2.06611 -5305 4 53.4463 22.3007 10.5387 10.5159 5.84972 4.87058 -5306 4 52.7807 22.2562 9.19728 -3.40401 -0.944397 -1.81328 -5307 6 22.3502 5.78024 2.67711 -1.19821 4.70475 8.9403 -5308 4 22.3462 5.61537 3.63751 1.98719 -8.03511 -7.01348 -5309 4 22.5962 4.95479 2.25163 2.53332 -12.0932 -0.158426 -5310 6 15.4205 16.2192 21.8867 5.02822 24.0999 -40.4778 -5311 4 14.4784 16.2102 22.0595 -10.022 -3.20892 10.2198 -5312 4 15.4767 16.6809 20.9929 2.09736 -16.6333 30.6862 -5313 6 28.7089 41.2927 33.91 5.52796 3.54283 5.25404 -5314 4 28.727 40.4953 34.4564 -2.79359 -2.24742 -0.170863 -5315 4 27.7951 41.4466 33.6263 4.57527 -2.88437 3.84631 -5316 6 9.01739 31.2727 18.2059 -18.1749 -3.84142 11.7815 -5317 4 8.98151 32.2312 18.3694 0.025829 -3.44513 1.18933 -5318 4 8.52849 30.7949 18.9304 13.8496 11.5721 -17.6376 -5319 6 20.5529 20.3981 18.1799 -10.2473 -3.12886 -8.71499 -5320 4 21.0329 20.6151 18.9854 0.125323 4.65459 7.73128 -5321 4 19.8496 21.0773 18.075 13.4895 -10.4913 3.92819 -5322 6 53.9703 14.7072 37.8312 5.01214 -4.5628 8.74013 -5323 4 53.4666 15.4974 37.9319 -5.56379 24.6001 14.4542 -5324 4 53.6093 14.375 37.0321 1.20033 -18.5897 -21.23 -5325 6 28.9035 15.3885 18.8586 45.4636 -15.1916 -0.680493 -5326 4 29.8469 15.0873 18.5932 -41.6456 12.1347 6.71251 -5327 4 28.9115 15.3505 19.8299 -3.5302 1.25595 -2.12016 -5328 6 2.00256 25.8212 18.9096 3.72723 11.471 14.7099 -5329 4 2.26458 26.6216 18.4327 2.14682 1.88771 -0.892997 -5330 4 1.76414 25.179 18.2501 -5.23937 -11.562 -15.1322 -5331 6 53.2507 40.704 24.2965 8.91441 12.4597 1.37217 -5332 4 53.4683 39.7911 24.0958 -2.511 -10.6834 -0.444896 -5333 4 54.079 41.1598 24.0633 -8.96863 1.63956 3.52407 -5334 6 47.5231 32.0042 22.8531 -14.3462 4.46803 -6.08063 -5335 4 47.3408 32.7709 23.4273 6.00779 -4.56073 2.25025 -5336 4 48.2766 31.5253 23.2067 4.67997 4.39959 7.43042 -5337 6 24.6197 26.1463 33.0089 -12.4366 -5.18424 3.68853 -5338 4 24.4183 25.6868 33.835 -4.3875 -0.159577 -1.83724 -5339 4 25.4547 26.5812 33.1385 10.0429 5.3772 -3.83199 -5340 6 21.3442 17.0884 39.4824 -9.75867 4.42788 -12.86 -5341 4 22.0786 16.6105 39.8509 9.0034 -0.419098 8.66004 -5342 4 20.9617 17.649 40.1682 3.71874 -0.284678 5.70811 -5343 6 11.0324 40.4486 17.0358 15.7971 -30.8577 -26.0801 -5344 4 11.6842 41.1185 17.2103 4.65986 12.9737 2.4903 -5345 4 11.491 39.8695 16.3608 -26.1319 15.9634 25.4848 -5346 6 20.3416 21.2702 39.8615 -24.9835 10.9638 22.3655 -5347 4 20.689 20.9793 39.0389 13.9219 -9.37305 -28.7546 -5348 4 21.0638 21.2843 40.4958 4.25493 1.29328 -0.298347 -5349 6 2.11091 29.6941 22.5934 -5.9509 -23.8702 -11.6938 -5350 4 1.45034 28.9715 22.5035 1.67869 13.3355 3.97539 -5351 4 2.94117 29.2559 22.3631 0.0654014 9.01208 -1.60678 -5352 6 36.7558 30.2897 35.4506 24.3729 -18.3256 16.5828 -5353 4 36.1768 30.1398 36.2224 6.47664 5.98183 -7.75951 -5354 4 37.6324 29.8684 35.7011 -26.9845 14.5763 -5.36474 -5355 6 12.9471 4.31284 37.9204 -6.90268 -11.166 6.10722 -5356 4 12.3078 3.59731 38.1765 12.7034 25.1114 3.17689 -5357 4 12.7446 5.19856 38.3152 -2.40344 -19.0082 -2.01981 -5358 6 38.3332 5.26794 18.4655 -19.3496 19.9027 -29.1997 -5359 4 37.4721 5.17942 18.8804 2.72791 -1.29988 8.64573 -5360 4 39.0241 5.01488 19.0552 15.587 -10.1496 24.0772 -5361 6 10.4858 9.23289 21.7404 -25.2332 -4.10139 2.16313 -5362 4 10.1465 9.25623 22.657 12.6022 -3.18555 -3.91704 -5363 4 11.447 9.27854 21.7188 5.40032 0.87934 7.2107 -5364 6 0.505771 41.0407 17.3245 -0.427706 37.3637 0.906459 -5365 4 1.03474 40.3115 17.5973 10.8601 -24.0642 8.3812 -5366 4 1.07952 41.8285 17.484 -10.202 -14.0113 -5.73388 -5367 6 4.10283 5.07754 6.43738 -38.2782 -14.6693 -26.7901 -5368 4 4.80956 4.44559 6.48511 17.8781 -6.62955 4.00539 -5369 4 4.33824 5.81877 6.9517 16.1672 26.1823 21.8329 -5370 6 11.4353 25.4218 0.164599 -6.84764 4.42394 -1.26617 -5371 4 11.3082 26.3017 0.56247 4.23965 -3.25035 1.30302 -5372 4 12.32 25.1006 0.40702 -4.64442 7.63092 -0.276853 -5373 6 7.41885 21.5502 8.10769 10.495 -13.722 -26.2993 -5374 4 7.61759 21.2522 7.17802 -11.0567 9.56016 28.8323 -5375 4 8.26229 21.8826 8.44859 -7.90548 -1.09713 -4.6635 -5376 6 47.5869 16.3678 25.2584 -15.0789 15.5873 -32.807 -5377 4 46.6352 16.1327 25.0388 32.9447 8.00435 6.4503 -5378 4 47.9767 16.8704 24.4584 -11.2605 -20.3751 33.7323 -5379 6 30.9209 19.4939 39.8451 -11.8548 28.7526 -24.1689 -5380 4 31.8555 19.5183 40.0202 17.1254 -10.6903 10.4692 -5381 4 30.8076 20.3562 39.3598 -8.87252 -26.4956 11.5622 -5382 6 20.3775 24.0331 39.393 16.2123 32.2964 -6.62361 -5383 4 19.46 24.2872 39.3788 -17.3162 -0.971439 2.40317 -5384 4 20.4139 23.0995 39.5119 -7.32592 -29.4126 2.4841 -5385 6 45.906 21.2665 41.1719 -24.2736 -11.4825 -0.885762 -5386 4 46.5804 21.1569 41.8486 15.7955 10.6383 -1.5802 -5387 4 46.0859 21.9477 40.5132 15.7742 6.36757 6.57249 -5388 6 32.5682 28.1996 30.46 3.6658 -10.99 6.0107 -5389 4 32.938 27.299 30.6104 -6.7941 21.8776 -2.09353 -5390 4 33.2105 28.8285 30.8344 -2.85996 -8.65293 -4.24176 -5391 6 18.0144 1.30598 27.0418 -16.6632 -1.71712 -0.445992 -5392 4 17.1007 1.69106 27.0468 26.0213 -5.17059 4.63351 -5393 4 18.4653 1.60291 27.8546 -9.34219 2.14994 -8.02835 -5394 6 39.3706 24.9704 21.8707 -3.8719 -7.6304 -3.05608 -5395 4 39.4638 25.9303 22.0078 -2.06007 -5.24545 2.56571 -5396 4 38.5004 24.7369 22.2528 8.08795 9.92494 -4.1564 -5397 6 33.5838 21.3134 22.0984 8.18441 -4.13225 6.82001 -5398 4 32.7138 21.3502 21.682 2.4933 6.37883 -5.99313 -5399 4 34.1113 22.092 21.8324 -12.1677 -4.37971 -1.53996 -5400 6 40.113 14.9986 15.7558 -14.3933 -54.3129 -47.4443 -5401 4 39.335 14.6192 15.2293 31.4969 18.6384 20.9479 -5402 4 39.7901 15.7154 16.2477 -17.7573 36.9578 24.811 -5403 6 32.6916 17.9228 6.36161 -9.89813 9.73379 -21.0853 -5404 4 32.6423 17.3002 7.0662 1.70901 -17.6566 26.5232 -5405 4 32.2464 17.4542 5.63975 -0.790726 3.03073 -5.51736 -5406 6 50.4678 15.9334 31.144 -39.7004 -26.5385 31.9374 -5407 4 51.253 16.1743 30.7093 39.9028 11.8107 -24.2063 -5408 4 50.5343 14.9829 31.3801 -1.18751 16.0768 -7.78774 -5409 6 23.825 29.3336 31.6412 17.8706 -6.79638 -8.14744 -5410 4 23.7507 29.695 30.7549 -4.03414 2.57591 0.878238 -5411 4 24.7016 28.8907 31.6365 -14.4802 6.46497 6.02506 -5412 6 25.0497 41.6479 38.28 3.49637 2.98657 -6.73496 -5413 4 25.6848 41.2957 37.6072 -14.3525 10.6226 12.6055 -5414 4 24.5759 0.544247 37.957 10.7828 -14.7666 -1.7986 -5415 6 14.3338 25.4719 8.00129 -34.0608 -17.9542 9.33499 -5416 4 15.0375 25.807 7.49197 32.7442 17.1809 -19.3974 -5417 4 13.7504 25.049 7.33286 9.67269 6.09785 11.4563 -5418 6 17.2157 20.7463 5.33337 -33.6161 12.1619 46.6806 -5419 4 17.4746 20.2104 4.61987 19.6997 -12.8632 -39.6831 -5420 4 17.6039 21.6267 5.33982 9.69266 2.06371 -12.0346 -5421 6 18.8632 10.9532 23.7128 -6.45661 -28.7698 -18.1749 -5422 4 18.5024 10.4645 22.9505 4.54871 -4.25462 9.96764 -5423 4 18.7195 11.8343 23.4273 2.43458 32.1183 3.28403 -5424 6 7.79185 41.3929 11.0465 3.42517 6.73563 9.75028 -5425 4 8.03468 40.5075 11.3396 -5.29569 0.405018 -3.04036 -5426 4 8.54504 0.0288503 11.3371 -5.83581 0.184768 -2.76634 -5427 6 48.7029 23.1861 34.0656 -21.7207 -4.36764 -18.9996 -5428 4 48.0685 22.9631 33.3267 17.6914 7.49561 22.5851 -5429 4 49.5647 23.2306 33.645 9.38657 -0.0360042 -3.96825 -5430 6 53.7171 23.5593 15.3279 7.98903 18.1369 9.52531 -5431 4 53.9889 24.0987 14.5512 -16.5338 -16.4319 -0.0123194 -5432 4 53.1679 22.8017 15.1046 0.0193492 2.24596 -12.2178 -5433 6 22.2331 5.62812 9.84443 -1.57081 2.06392 2.32933 -5434 4 21.8309 4.81719 9.48029 9.17546 11.008 0.0652314 -5435 4 22.6135 6.1669 9.11622 -10.9942 -17.7486 8.8339 -5436 6 33.6597 8.39756 9.07438 12.888 -3.30103 7.28088 -5437 4 32.9598 8.97334 9.38893 -12.3292 7.33717 0.65351 -5438 4 33.4682 8.16911 8.16186 -5.09418 6.09353 -6.44604 -5439 6 47.3119 37.7194 20.3363 21.5156 22.744 3.03657 -5440 4 47.6473 37.5407 19.4464 -9.46862 -8.33692 4.35957 -5441 4 46.6883 37.0359 20.5464 -12.6113 -19.4741 -3.99141 -5442 6 30.8566 16.7294 10.6197 -45.1927 -36.7422 15.3603 -5443 4 30.4293 17.2093 11.3782 10.0419 -7.15869 -15.9692 -5444 4 30.3248 15.8445 10.5087 28.8517 44.18 3.4025 -5445 6 48.1145 27.7388 10.1259 3.61398 12.7601 13.975 -5446 4 49.0121 27.5791 10.4269 8.16567 7.74751 7.8449 -5447 4 47.9875 27.049 9.49259 -14.0608 -13.1923 -17.2023 -5448 6 27.3333 38.6223 25.6028 2.23096 -19.4823 3.9502 -5449 4 28.2552 38.3493 25.5855 1.31221 -11.4567 4.08925 -5450 4 27.4115 39.4856 25.2253 -6.51803 21.9055 -3.11379 -5451 6 33.3641 5.73966 21.4502 -17.8674 16.1521 -18.7045 -5452 4 32.7333 6.1391 20.8022 11.3762 -13.0233 18.1576 -5453 4 34.2053 6.04196 21.1266 17.0109 2.35293 -3.511 -5454 6 25.3113 5.14231 4.52483 0.627568 -0.448638 -4.7772 -5455 4 25.9311 5.01166 5.26368 -5.83567 -1.85096 0.781095 -5456 4 24.4169 4.85751 4.79359 12.9854 0.158453 3.02285 -5457 6 40.4761 35.641 19.148 -1.79116 -1.08437 4.96155 -5458 4 40.617 35.2798 20.0294 1.97887 -12.6912 2.42284 -5459 4 40.4316 36.5735 19.3404 -1.08207 12.5153 -8.94186 -5460 6 49.6577 30.6259 19.0198 10.1565 -2.14928 -32.2041 -5461 4 49.9169 29.8714 18.4657 1.24638 0.0316256 -4.24874 -5462 4 49.4705 30.2089 19.8368 -7.31172 -12.6811 36.7039 -5463 6 42.1447 28.3235 17.0346 32.2065 -21.7575 -5.76428 -5464 4 41.8825 28.1658 16.1189 -9.06503 7.62036 -2.3435 -5465 4 42.9622 27.7534 17.0825 -24.1402 18.2728 2.552 -5466 6 47.7039 24.5139 36.3396 16.4403 6.39896 -6.79461 -5467 4 46.9537 23.9582 36.5487 -4.01092 -10.0931 -4.11437 -5468 4 48.0889 24.2445 35.4833 -10.0455 -7.86437 4.89019 -5469 6 19.3463 26.9837 19.8062 -14.9609 -0.640093 12.1457 -5470 4 19.5138 26.0435 19.7544 7.81166 -12.6546 -12.1749 -5471 4 18.7209 27.0489 20.5386 2.91516 7.38851 -4.99075 -5472 6 47.0534 26.8134 37.524 14.5946 -27.4581 20.3182 -5473 4 46.5999 27.4025 36.9765 -27.9132 42.868 -22.1392 -5474 4 47.3287 26.1433 36.896 5.92816 -9.16339 3.59921 -5475 6 9.30604 24.6864 40.2824 32.5721 -4.72803 4.84631 -5476 4 9.7425 23.8424 39.9878 -14.1318 19.2209 8.44319 -5477 4 10.0514 25.1942 40.7028 -19.8613 -12.5192 -10.8686 -5478 6 14.4861 17.9115 14.2864 12.9549 -2.10551 -8.28408 -5479 4 13.7677 18.2592 13.7435 1.92348 1.2648 2.86628 -5480 4 15.2633 17.8567 13.6783 -18.4643 2.67645 15.1406 -5481 6 37.1346 38.6824 18.7128 7.24689 -5.58535 -9.53541 -5482 4 36.7159 39.5508 18.578 6.84706 -0.690413 -9.37485 -5483 4 37.7177 38.457 17.9456 -10.6272 10.0511 7.65618 -5484 6 11.4119 5.91281 21.4549 8.51563 -6.63227 17.2429 -5485 4 12.0074 5.45436 22.0841 -12.0343 5.82261 -11.8758 -5486 4 10.9825 5.24051 20.9122 -1.087 -4.70833 -2.40093 -5487 6 4.25375 30.708 16.2346 29.3973 -34.9884 0.269827 -5488 4 4.09384 31.4404 15.6668 -11.3131 25.7038 -10.6546 -5489 4 3.7498 30.7826 17.0293 -13.4231 7.50595 13.7704 -5490 6 17.6719 16.0027 27.067 -23.8279 -26.0778 -36.6424 -5491 4 17.4271 15.046 26.968 10.0078 22.1048 9.82572 -5492 4 17.2008 16.3672 26.2667 15.5193 1.39518 21.9495 -5493 6 36.5109 8.65039 40.4308 12.8187 7.82554 4.51092 -5494 4 36.6212 9.57953 40.6523 1.70353 1.63484 0.0365135 -5495 4 35.6422 8.38915 40.7323 -7.59123 -4.26386 -1.28756 -5496 6 13.6114 12.9582 3.02589 -9.62347 -2.84414 10.0553 -5497 4 13.2363 12.4097 3.76862 19.3807 16.1747 -17.4749 -5498 4 14.4444 13.4268 3.2396 -7.87441 -9.64772 8.81761 -5499 6 38.5595 20.1494 21.6232 12.4359 -2.6335 16.4863 -5500 4 39.2259 20.3435 20.9591 -1.48691 0.443177 -6.45697 -5501 4 37.7118 20.0829 21.2013 -17.1516 -4.14152 -12.2545 -5502 6 50.9933 10.2578 30.842 -13.0607 -20.693 1.71035 -5503 4 51.4592 11.0512 30.6346 13.219 20.5706 -0.472754 -5504 4 50.4501 10.1493 30.0523 -4.00654 -4.85851 -2.78428 -5505 6 16.2749 2.41767 41.3132 30.43 46.2693 -10.4997 -5506 4 15.891 1.63581 41.6436 -18.412 -43.9133 0.0464609 -5507 4 16.2795 2.47169 40.3396 -9.09423 -14.5759 6.47164 -5508 6 16.5834 4.98938 41.8776 -7.21709 18.0228 -35.1788 -5509 4 16.7462 5.00964 0.881122 10.2158 10.5242 44.5139 -5510 4 16.3516 4.0781 41.7536 -3.71457 -12.9135 -9.58407 -5511 6 38.2173 37.6461 20.9885 34.7311 9.53448 3.02785 -5512 4 38.1039 38.1836 20.1861 -3.89758 -6.06348 6.62032 -5513 4 39.1638 37.7895 21.271 -30.6928 -4.57838 -6.40603 -5514 6 27.3006 1.89931 15.7822 -29.9599 0.296682 7.03709 -5515 4 27.5073 1.31215 15.0574 1.93116 -3.76907 -9.96281 -5516 4 26.3073 1.90747 15.8082 23.9237 -0.0762349 1.33551 -5517 6 29.0265 12.4386 37.8107 0.525722 -10.271 3.33822 -5518 4 29.5022 13.2884 37.7591 0.646351 -6.15481 8.15455 -5519 4 29.2991 11.9227 38.6151 -0.523918 21.8031 -11.8471 -5520 6 46.0742 20.1649 18.9021 10.3528 7.89056 -10.7305 -5521 4 45.1842 20.5502 18.8696 3.90233 0.901411 -3.14496 -5522 4 46.6469 20.7119 18.3183 -8.66547 -7.99067 8.59505 -5523 6 2.04022 38.6829 18.5084 -2.98341 9.82285 -40.3455 -5524 4 2.90324 38.7749 18.9245 -0.612017 -3.29975 20.9344 -5525 4 1.3228 38.3823 19.0758 6.43327 -3.78011 20.6074 -5526 6 44.0503 24.9822 25.9794 4.67294 -4.59524 3.88497 -5527 4 44.3373 24.0607 26.0767 4.76241 4.2408 6.41339 -5528 4 43.5759 24.9717 25.1449 -4.92835 3.44315 -2.97359 -5529 6 5.98031 26.6293 4.53551 9.30387 5.64625 14.1271 -5530 4 6.57491 27.1353 5.14729 -11.3776 -17.0368 -12.135 -5531 4 6.21313 25.677 4.5841 -4.82905 19.4284 -2.02229 -5532 6 0.0924267 23.2133 10.9333 1.42961 0.53672 3.80218 -5533 4 0.717354 23.7388 10.4004 2.9288 -9.65077 10.1872 -5534 4 0.580921 22.6863 11.5989 -3.01683 9.30052 -9.37626 -5535 6 39.1222 20.6154 12.8741 28.3348 2.95161 0.461931 -5536 4 40.0468 20.8249 13.1753 -23.4009 -9.33487 -2.82098 -5537 4 38.9932 21.1408 12.0685 -0.0080483 -0.226832 2.68059 -5538 6 39.959 39.9495 18.871 8.01281 1.93571 -21.8826 -5539 4 39.6441 40.4313 18.0693 6.09748 -11.7745 18.4856 -5540 4 39.3412 40.1359 19.5607 -16.2687 5.42221 11.8382 -5541 6 49.288 23.0046 30.5128 21.2206 -9.75551 18.5897 -5542 4 49.5389 23.7528 30.0013 -1.98497 24.1116 -29.9204 -5543 4 49.9896 23.0569 31.1809 -5.40626 -11.587 6.30696 -5544 6 10.3545 2.34292 9.14765 -20.562 40.259 12.8074 -5545 4 10.1012 1.5797 8.68555 -3.02669 -36.876 -18.9145 -5546 4 9.58966 2.94108 8.9894 20.4134 -0.423974 9.05106 -5547 6 9.6115 40.9317 19.7379 12.0905 -27.6191 -4.08509 -5548 4 9.69139 40.7751 18.7589 3.32448 -0.840478 24.839 -5549 4 9.96472 40.0953 20.2033 -15.7711 32.9781 -27.126 -5550 6 29.2535 5.10379 17.4957 6.62295 15.7752 6.05206 -5551 4 28.9547 4.7998 16.6324 -1.76299 0.290572 -5.22762 -5552 4 29.5626 6.02275 17.3534 -3.29284 -14.1281 1.20249 -5553 6 27.0956 15.411 3.22262 8.43004 -47.4217 3.28637 -5554 4 27.2677 16.3043 3.38591 1.16524 52.1129 6.18754 -5555 4 27.741 14.9724 3.82188 -13.792 3.46242 -10.72 -5556 6 32.8341 39.3821 25.1177 -1.66938 -44.1854 21.376 -5557 4 32.6253 40.2767 24.9331 -7.27917 31.8978 1.68524 -5558 4 32.4689 39.1753 26.0219 6.68592 11.3878 -26.9617 -5559 6 34.9613 7.8883 31.2358 4.6626 36.0744 6.61898 -5560 4 34.1778 8.39814 31.5057 7.62156 3.23778 -2.6687 -5561 4 34.6431 7.01199 31.2355 -6.57887 -35.8668 -2.78431 -5562 6 6.13276 36.7597 26.1434 10.8988 16.6869 20.3463 -5563 4 6.63888 37.4372 26.6797 -12.2659 -21.448 -21.9021 -5564 4 6.61066 36.5785 25.3331 5.0666 0.722926 -2.43587 -5565 6 6.00975 25.8323 24.1014 -4.47961 0.932019 -2.36624 -5566 4 6.35352 25.3647 24.9068 -18.3984 14.8695 -13.0656 -5567 4 5.16189 26.3111 24.2876 18.65 -15.8322 7.58859 -5568 6 45.6302 24.3945 2.56021 19.8484 -5.54431 -0.0961329 -5569 4 46.4674 24.0527 2.19931 -2.34639 0.0383291 -2.49188 -5570 4 45.6784 24.1611 3.48508 -4.52597 -1.56916 11.2469 -5571 6 15.5147 11.7041 32.683 14.9804 20.126 19.7749 -5572 4 15.7333 12.537 33.1619 -4.31998 -20.325 -9.45866 -5573 4 14.9494 12.0119 31.9786 -9.0483 1.88099 -11.1618 -5574 6 46.4109 17.7015 37.4781 -27.0258 -32.7931 -28.9932 -5575 4 46.5427 17.8951 38.3867 3.19976 6.65122 29.0636 -5576 4 45.8763 16.8534 37.4192 15.4316 28.8096 -0.764517 -5577 6 39.7197 20.9143 18.534 -24.0731 20.2285 32.8184 -5578 4 40.3775 20.5463 17.9571 20.7324 -0.0260386 -6.5243 -5579 4 40.0771 21.5962 19.1648 -0.0511872 -19.8333 -22.8182 -5580 6 23.8035 28.041 36.6748 9.0016 14.1447 -6.24075 -5581 4 23.3139 27.2938 37.064 2.44252 16.2828 7.25552 -5582 4 23.789 28.845 37.2599 -7.88527 -27.7019 -2.97202 -5583 6 23.2344 0.634844 30.8976 -0.384503 -14.0448 -5.97485 -5584 4 23.3889 41.8653 31.5825 6.30765 2.44689 -9.38002 -5585 4 23.8441 0.49945 30.133 -8.72578 -2.57312 14.648 -5586 6 37.1436 6.89172 28.2858 -3.37167 6.44507 30.6351 -5587 4 36.8056 6.23733 28.9583 11.2574 17.9183 -21.3683 -5588 4 37.4325 7.68669 28.8192 -8.94015 -21.4647 -17.7418 -5589 6 3.23535 6.60909 12.3935 -1.87368 1.73448 8.36027 -5590 4 3.03832 6.9284 11.4867 8.20532 -9.84476 7.71099 -5591 4 3.52123 5.67427 12.3822 -6.77188 11.8795 -6.70084 -5592 6 12.6173 19.1518 31.1213 -5.69854 -18.2223 8.29425 -5593 4 12.5903 18.2248 31.5183 -0.203161 27.8336 -18.7857 -5594 4 12.2771 19.1425 30.2049 2.23067 -5.60852 14.6148 -5595 6 15.1884 38.3149 41.5578 -3.57026 -0.303434 0.776802 -5596 4 15.4085 38.7623 40.7331 -1.55695 3.41656 0.7558 -5597 4 16.0064 37.8692 41.7958 4.70682 -3.66196 2.37744 -5598 6 49.6308 33.3399 19.6427 -23.754 -26.2674 -4.71234 -5599 4 48.6425 33.4171 19.8493 35.7001 -9.4047 -10.4581 -5600 4 49.8006 32.395 19.3286 -9.63678 35.3831 11.1391 -5601 6 6.36026 2.78098 29.8944 3.74937 13.951 -9.77631 -5602 4 6.39713 3.75696 29.8119 -0.635871 -14.0149 2.80012 -5603 4 6.09114 2.63212 30.8044 -1.55083 -4.44243 9.60337 -5604 6 13.1715 31.7798 30.2783 -11.6407 3.9064 -21.9894 -5605 4 12.793 31.9725 29.3819 8.72012 -0.590438 18.6573 -5606 4 12.9685 30.8401 30.4245 2.82441 5.28785 4.26217 -5607 6 32.3245 32.246 24.8932 -0.334642 -17.4514 3.51608 -5608 4 32.5833 31.3985 24.4266 1.55373 29.7789 3.70352 -5609 4 32.7413 33.0821 24.5914 4.2936 -14.9539 -9.40787 -5610 6 41.9919 14.5701 37.4124 -31.8928 -38.2057 -11.1184 -5611 4 41.1925 13.9916 37.278 11.7187 28.3557 2.93562 -5612 4 42.6351 13.8531 37.4242 20.2579 6.94588 1.70752 -5613 6 11.8923 7.24234 27.6655 -13.1666 -25.4093 6.94854 -5614 4 11.7936 6.42612 28.2118 8.91213 18.8361 -2.40188 -5615 4 11.255 7.06027 26.9538 4.64331 9.73453 -0.841263 -5616 6 14.1973 37.538 6.88791 4.07782 -38.2298 -28.3639 -5617 4 14.4575 38.4426 6.80778 6.05638 30.4198 1.96843 -5618 4 14.5936 37.1092 6.07523 -12.6749 10.0326 27.426 -5619 6 14.2479 30.6948 36.0545 7.37408 36.4971 9.0133 -5620 4 14.3981 30.7629 35.1101 2.39159 -10.6067 -11.9788 -5621 4 14.1779 29.7876 36.2972 -1.09854 -35.7585 -0.14866 -5622 6 16.4334 33.6494 5.49228 -9.96541 -28.1856 -5.39099 -5623 4 16.7983 34.5397 5.45321 9.37649 -3.55324 -12.1003 -5624 4 16.7788 32.9912 4.81355 -0.655183 31.9156 12.6517 -5625 6 23.0317 17.1547 7.8473 13.6053 -0.132883 9.10362 -5626 4 22.1841 17.362 7.40272 9.91908 10.567 10.3381 -5627 4 23.4804 17.9296 8.30446 -24.7767 -19.3244 -18.4116 -5628 6 51.7425 20.8913 27.7088 32.6403 -5.30395 6.54704 -5629 4 51.4526 20.615 28.6066 9.31531 5.01366 -13.1678 -5630 4 52.7523 20.9899 27.7096 -40.0215 -4.95426 2.55021 -5631 6 2.19474 27.6072 28.8013 -23.9703 3.8216 12.4498 -5632 4 2.89306 28.2617 29.0045 8.22653 -14.998 -10.5048 -5633 4 2.42593 26.8662 28.2089 10.4722 10.3682 5.46115 -5634 6 17.2069 14.3387 7.70681 0.210359 -30.5014 22.2216 -5635 4 16.8342 14.1932 8.62484 13.2745 1.87397 -27.442 -5636 4 17.791 13.5503 7.49447 -17.8498 26.4292 5.4189 -5637 6 12.462 8.93964 14.7065 0.798528 8.71873 -6.67623 -5638 4 12.2438 7.98523 14.5568 11.6803 11.8078 17.0064 -5639 4 13.0577 9.12873 15.4809 -12.5262 -17.6243 -12.8578 -5640 6 42.4139 38.0579 9.76413 -20.5008 17.2265 16.0611 -5641 4 43.2035 37.8944 10.2554 20.3834 -6.45835 6.72371 -5642 4 41.8905 38.6035 10.3913 3.31942 -7.4886 -15.3201 -5643 6 51.8227 30.3513 28.272 -27.6927 -20.9124 31.2363 -5644 4 51.4089 31.1514 27.9711 0.163888 16.7369 -10.597 -5645 4 52.6546 30.2313 27.8441 24.1641 3.9866 -16.3823 -5646 6 0.181148 18.531 4.58976 -5.95747 22.8787 14.3331 -5647 4 0.30783 18.164 3.72574 1.94264 -10.8238 -19.8991 -5648 4 0.385506 17.861 5.23812 2.38695 -15.8688 4.81738 -5649 6 34.1492 0.61754 2.99129 -49.6439 4.42439 -16.0687 -5650 4 33.2398 0.938351 2.63038 43.5613 -10.8791 15.5023 -5651 4 34.8325 1.13587 2.566 3.67212 10.3309 -6.27046 -5652 6 49.171 17.2374 23.1529 12.6877 -22.0026 -17.2704 -5653 4 50.1002 17.5391 23.0823 -12.4494 -3.65532 2.68691 -5654 4 49.1558 16.3609 22.6932 2.16788 22.8154 9.36775 -5655 6 23.1488 6.5083 23.6124 -20.5997 37.6057 -45.0229 -5656 4 23.0491 7.12001 22.8007 18.1878 -21.95 27.0503 -5657 4 22.2316 6.45775 23.8939 -1.28085 -6.53623 13.7239 -5658 6 11.0806 24.0842 29.2705 -8.73998 -10.3514 -18.9502 -5659 4 11.2441 23.4599 28.5168 0.0150655 10.4905 16.9308 -5660 4 11.7296 23.9083 29.9561 7.87164 -2.5542 2.12029 -5661 6 36.5429 4.08242 21.672 0.786556 -8.94696 -15.3954 -5662 4 36.4501 4.49554 22.5359 -3.35109 8.47972 1.84417 -5663 4 36.356 4.76727 20.9996 1.47044 -5.20042 11.1851 -5664 6 31.3053 25.6355 24.591 -3.66138 3.71718 3.54675 -5665 4 31.1335 26.2845 25.3159 5.93159 -20.4343 -13.8963 -5666 4 32.0778 25.0682 24.8002 -7.66178 11.3294 7.22687 -5667 6 42.6065 23.0403 14.7613 -16.8309 4.03618 -45.3098 -5668 4 42.9655 23.4598 13.9577 -8.276 -4.36486 -1.00498 -5669 4 43.204 23.3098 15.4118 29.6291 10.3091 46.448 -5670 6 14.3159 11.6727 8.8813 -14.5655 -17.9373 -12.2817 -5671 4 13.3434 11.4421 8.85146 29.9821 6.96631 -2.22077 -5672 4 14.7728 10.9717 8.34565 -11.3371 15.3318 14.175 -5673 6 21.498 2.14139 3.39648 14.7702 -17.8734 -6.06988 -5674 4 22.405 2.21099 3.73647 -11.0312 3.8274 -0.37696 -5675 4 21.4855 1.24815 2.9799 -4.51333 14.3419 9.54204 -5676 6 22.4606 27.6741 39.0725 -9.38699 -8.57051 -12.0691 -5677 4 22.9487 28.2157 39.6788 9.87489 12.9386 7.45564 -5678 4 22.251 26.9021 39.5804 -3.7481 -10.0177 3.53978 -5679 6 37.2705 33.4961 30.0614 -4.9469 -17.1986 11.1636 -5680 4 36.5019 32.9393 30.3108 14.0133 8.69925 -1.52787 -5681 4 38.0636 33.0902 30.4641 -13.5236 2.40347 -6.71067 -5682 6 41.8394 20.8621 40.0097 -20.8091 -17.9415 -11.9484 -5683 4 40.8821 20.7467 40.2088 17.4772 5.45688 -4.89215 -5684 4 42.2425 21.2111 40.795 8.11745 4.61319 15.3924 -5685 6 10.0509 31.1054 22.2556 20.3961 -18.8014 17.2446 -5686 4 9.98499 30.8639 23.2007 -4.95143 3.66172 -13.3958 -5687 4 9.23459 31.4918 21.9926 -24.2979 8.76968 -3.95477 -5688 6 24.2243 35.3747 6.62617 -9.42531 -3.96828 -6.7527 -5689 4 23.2865 35.2144 6.56466 -9.91939 -6.68958 -24.4488 -5690 4 24.2401 35.6133 7.54088 22.4532 10.3619 17.5563 -5691 6 54.2249 13.3694 18.759 -24.737 -0.349871 -1.41807 -5692 4 53.5933 13.3703 18.006 15.3609 1.78219 9.05355 -5693 4 53.6566 13.499 19.5435 10.7967 -0.400371 -8.89572 -5694 6 12.4855 25.1013 17.4456 -6.57337 13.5018 5.68311 -5695 4 11.9686 25.7405 17.9864 9.67417 -13.0798 -6.23069 -5696 4 12.9177 24.4729 18.0482 -8.67745 6.31928 -4.55572 -5697 6 22.3956 33.969 18.8874 -5.8063 -1.6479 -7.81353 -5698 4 22.8035 34.4497 18.1359 -8.0332 -6.19684 5.18696 -5699 4 21.6693 33.408 18.5182 22.6878 13.045 2.20471 -5700 6 24.4435 12.9292 5.84415 8.74588 -19.8564 16.0901 -5701 4 24.6262 13.8512 5.99703 -0.326218 20.1414 -4.57271 -5702 4 23.8078 12.8376 5.13214 -2.90401 5.95194 -4.82348 -5703 6 13.3959 11.2335 28.6038 -6.74888 -5.61354 -5.54718 -5704 4 13.7674 10.4842 28.0847 -9.93712 8.82772 12.9583 -5705 4 12.6218 10.8864 29.0903 8.08376 -4.51111 -11.0518 -5706 6 20.9645 34.7015 21.139 -6.51648 1.45471 -0.425004 -5707 4 21.4543 35.0255 21.9119 2.52902 -3.67403 -7.94594 -5708 4 21.5071 34.7067 20.3201 -1.1119 -0.149268 16.7291 -5709 6 37.136 34.5081 26.161 6.62209 -8.97684 -22.2932 -5710 4 37.2438 34.333 25.2112 -5.73965 -6.14541 10.65 -5711 4 37.5173 35.375 26.2088 1.33918 12.2816 12.8311 -5712 6 49.3593 27.1123 23.4681 27.9614 -13.0657 2.71617 -5713 4 48.46 27.3383 23.3348 -38.0547 10.3981 -3.53627 -5714 4 49.5827 26.632 22.6632 1.14175 -6.15755 -6.01297 -5715 6 2.6463 41.7198 27.6524 7.3894 17.9878 -25.5957 -5716 4 2.49639 41.7504 26.6775 -8.79282 -10.4379 14.5056 -5717 4 3.38399 0.440368 27.7439 -10.0848 -7.80081 10.7778 -5718 6 28.2486 5.66281 0.851705 -28.2484 -11.3463 5.20358 -5719 4 29.1342 5.88017 0.643235 30.8656 11.4658 -5.99415 -5720 4 28.269 4.69693 0.891643 -4.88577 1.64465 1.4719 -5721 6 46.3319 19.9354 30.6504 10.2867 19.401 8.99033 -5722 4 46.9123 19.9353 29.8821 -3.84989 -4.07474 -6.11394 -5723 4 46.5975 20.7732 31.0971 -12.3274 -18.5124 -2.17733 -5724 6 3.63748 25.7835 21.5531 -13.3498 -8.40935 -29.3244 -5725 4 3.82697 24.8656 21.7578 10.5845 0.467441 11.0774 -5726 4 3.24958 25.6945 20.6565 5.98204 10.7305 11.6574 -5727 6 2.75525 19.0991 29.6309 -15.3907 3.66354 13.2976 -5728 4 3.52302 18.6052 29.9384 7.69741 -2.11378 -3.28897 -5729 4 2.98375 19.5594 28.8227 11.6258 3.58084 -5.99316 -5730 6 11.8998 35.7779 24.2574 -1.81403 7.91701 -5.71356 -5731 4 12.4147 34.9912 24.3376 10.7342 -20.9531 7.85436 -5732 4 12.5443 36.3811 23.8879 2.19538 16 -3.69366 -5733 6 52.3427 30.4062 14.294 22.5839 4.39347 1.37497 -5734 4 52.8745 31.0934 14.7488 -8.66891 -1.23278 -4.46489 -5735 4 51.4935 30.7804 14.0876 -13.5204 11.8147 1.32314 -5736 6 0.0822874 24.3672 32.1291 -8.34182 -9.5272 -6.40877 -5737 4 0.828194 24.8082 31.7001 -5.59692 5.0286 6.41936 -5738 4 -0.0482457 24.7479 33.0025 4.35174 8.79498 5.58774 -5739 6 31.4966 23.7292 38.8152 19.1094 38.0757 -4.99319 -5740 4 31.5999 23.5133 39.7508 -8.21927 -12.2318 -1.63758 -5741 4 30.9751 23.0699 38.3783 -13.0662 -23.7861 4.62116 -5742 6 52.1169 21.6052 3.50792 14.3711 -14.904 -13.5765 -5743 4 52.8807 21.6364 2.89306 -16.3122 -4.91238 6.22228 -5744 4 52.1257 22.4771 3.8768 -2.65107 18.1744 9.91254 -5745 6 31.7478 33.9414 11.5999 6.40399 -14.705 -7.35618 -5746 4 31.326 34.316 12.3745 -3.98661 3.76902 9.36008 -5747 4 32.1024 33.0666 11.8569 -5.74966 15.1553 -0.43871 -5748 6 7.04869 17.6722 16.6738 15.5169 9.78585 -46.6303 -5749 4 6.86408 17.1452 17.4554 -1.12856 -17.4359 1.80272 -5750 4 7.18951 17.0724 15.8577 -9.09698 16.5018 49.1326 -5751 6 51.856 41.8666 22.1892 3.84753 25.5265 -21.3427 -5752 4 52.3772 41.4924 22.8897 9.65371 -13.9556 16.5062 -5753 4 51.0512 41.3628 22.1522 -12.8828 -14.9996 6.2925 -5754 6 50.8708 9.92691 25.9357 -19.3562 -16.2947 3.52683 -5755 4 50.5833 10.1225 25.0455 -2.85771 2.39787 -5.58996 -5756 4 51.6551 10.4289 26.0882 17.2727 16.0662 4.10656 -5757 6 8.99927 39.8664 13.8488 -8.14038 -13.6283 -23.156 -5758 4 9.59929 39.3497 14.3885 6.06913 -3.61279 3.55219 -5759 4 8.79522 39.3067 13.0547 7.60199 16.2117 22.1745 -5760 6 40.7023 25.5302 0.148896 6.79038 -13.4508 8.01702 -5761 4 40.3789 25.4701 1.07476 14.4856 1.96217 -11.1718 -5762 4 41.6802 25.6099 0.149801 -17.1473 -2.90233 2.89792 -5763 6 46.6909 7.84537 22.8702 9.17253 9.27189 2.7581 -5764 4 46.223 7.4121 23.6122 6.69651 11.5962 -1.82232 -5765 4 47.0858 8.70418 23.1544 -10.5797 -14.2101 5.83025 -5766 6 21.013 12.9106 9.96683 -11.4772 33.9385 12.3935 -5767 4 21.4714 12.292 10.5062 17.1864 -22.5118 18.142 -5768 4 21.2487 12.7153 9.07972 8.38308 -10.8862 -30.7653 -5769 6 24.8549 0.515446 28.6008 5.68052 19.4063 -7.13145 -5770 4 24.6132 0.0822417 27.7678 -2.25298 -0.561161 -0.933523 -5771 4 24.9931 1.46483 28.3802 -3.69568 -16.6941 4.65055 -5772 6 9.93738 22.6806 8.27387 -17.0851 30.8612 6.83622 -5773 4 10.4469 21.9921 7.84938 5.97494 0.327216 -18.4105 -5774 4 9.65147 23.3826 7.61609 12.4321 -25.0338 8.46255 -5775 6 33.2759 9.25001 23.8237 4.47891 -44.2955 15.8461 -5776 4 33.2652 10.105 23.448 0.909732 36.8069 -18.0196 -5777 4 34.1325 8.84557 23.5962 -5.93924 6.51534 1.57833 -5778 6 47.795 20.3665 34.2866 5.36639 25.6433 -13.2606 -5779 4 47.2589 21.0165 33.753 7.81309 -27.8153 16.882 -5780 4 47.2984 19.5618 34.502 -10.2742 8.68957 -7.27829 -5781 6 7.49437 13.498 41.0843 -1.51987 -1.91843 -16.5508 -5782 4 7.4491 13.1887 40.147 4.71488 4.53153 18.247 -5783 4 8.31974 13.1617 41.4819 -4.68073 -1.19795 -7.02436 -5784 6 9.95832 23.5973 1.60681 5.21402 2.49741 5.68021 -5785 4 10.4402 24.1882 0.998507 -5.12041 -6.82862 1.89989 -5786 4 9.65493 22.8254 1.1174 1.14228 -2.219 -8.51506 -5787 6 27.3184 14.1623 11.3341 -13.0256 18.3326 19.191 -5788 4 27.0532 14.8043 10.6617 -0.288735 -3.87647 -1.15481 -5789 4 27.1082 14.6278 12.1878 10.7132 -11.7932 -20.1286 -5790 6 25.8363 31.783 17.8928 12.257 -31.4953 -8.75538 -5791 4 26.5912 31.2312 17.6268 -16.3657 -3.28218 2.7807 -5792 4 26.257 32.5845 18.0942 8.13437 40.9862 10.9181 -5793 6 28.5106 34.3419 0.227626 33.3873 17.7784 12.057 -5794 4 28.9852 33.8482 0.904042 3.3493 0.859906 2.37016 -5795 4 27.7339 33.8559 0.0766936 -35.6263 -19.3635 -8.63216 -5796 6 39.4752 27.6784 22.7097 42.3367 15.2059 -23.9811 -5797 4 38.5679 27.9307 22.8105 -22.3645 11.7157 0.32019 -5798 4 39.9498 28.4084 22.1978 -16.9125 -22.6846 16.1018 -5799 6 19.4034 35.5119 37.6428 33.5095 -11.1022 16.798 -5800 4 18.7953 34.9333 37.2031 -16.031 -7.23993 -11.3762 -5801 4 20.0399 34.8524 38.0282 -15.2165 20.9239 -9.15559 -5802 6 40.2577 30.223 10.7322 40.2352 -13.6393 -47.8395 -5803 4 40.0003 30.153 11.624 -20.3139 3.96126 40.955 -5804 4 39.7054 30.7997 10.2038 -14.6911 14.5022 3.62333 -5805 6 44.8252 28.467 36.0943 -27.9317 -39.6182 20.2271 -5806 4 44.1 27.9067 36.617 42.0807 42.9759 -26.5645 -5807 4 44.8315 29.4044 36.3472 -5.71594 -8.07431 0.279077 -5808 6 17.9328 13.9421 34.2756 -23.0398 37.6904 -16.8553 -5809 4 17.2847 14.658 34.0723 21.6532 -14.16 -3.36915 -5810 4 17.4769 13.4978 34.9742 -2.33669 -21.4636 20.9706 -5811 6 22.7722 11.8049 25.9053 18.1639 13.4769 -8.32772 -5812 4 22.5143 10.954 26.1764 -32.0329 -27.8082 11.3637 -5813 4 23.7113 11.6387 25.939 19.9678 17.8754 -6.33473 -5814 6 27.9844 31.9785 40.3628 4.4159 -7.73511 16.6787 -5815 4 28.3104 32.752 39.9101 2.36742 5.81951 -9.83175 -5816 4 27.6866 31.3262 39.7216 -3.89657 2.92736 -3.90823 -5817 6 29.7056 5.13899 29.6966 36.1554 -28.1732 -9.81385 -5818 4 29.3242 5.52633 30.4675 -11.5775 13.5815 21.5043 -5819 4 30.5867 4.74321 29.9895 -34.1051 15.4003 -14.984 -5820 6 3.10893 21.4798 2.76501 -7.99866 -19.5262 -7.43282 -5821 4 2.82658 22.3873 2.73831 -4.86294 14.1814 1.21532 -5822 4 2.47005 21.0041 2.20282 6.80672 4.92349 5.4824 -5823 6 13.6497 30.6638 39.7451 -45.1888 -1.5 -27.4221 -5824 4 14.5316 30.8766 39.996 26.4643 7.88404 -4.33129 -5825 4 13.4124 30.9677 38.8135 13.6057 -6.06521 34.9266 -5826 6 39.188 23.0895 28.2562 15.2318 22.185 -40.3341 -5827 4 39.2961 23.1894 27.2636 -4.5014 -1.37473 28.8386 -5828 4 38.6302 22.3345 28.3879 -14.2617 -17.3372 5.24228 -5829 6 16.9988 23.7489 0.769214 20.7079 -15.4466 5.05665 -5830 4 16.2107 23.4786 1.24898 -3.68938 2.33828 -2.20359 -5831 4 17.6949 23.1909 1.19915 -10.9726 17.7258 -9.6056 -5832 6 0.328251 33.6592 13.0294 5.05621 13.0457 -18.8804 -5833 4 55.0348 32.9975 13.677 0.78154 12.2617 9.8199 -5834 4 0.388277 34.5816 13.3997 -6.36603 -34.6234 2.68168 -5835 6 49.1005 40.6595 16.9496 -9.76098 4.73909 -13.8177 -5836 4 49.2151 40.9775 16.0207 -4.23419 -6.48803 14.4163 -5837 4 48.1506 40.7848 17.1408 8.79948 2.71791 -6.65809 -5838 6 52.1337 39.9918 15.1756 26.7545 10.0433 -2.50902 -5839 4 51.9708 40.0067 16.1202 -6.38877 -4.81519 5.40892 -5840 4 51.3465 39.7494 14.7166 -22.4824 -4.17003 -7.64187 -5841 6 29.052 37.1033 37.836 19.097 -0.968932 -4.5801 -5842 4 29.682 36.5364 38.3049 -8.87198 1.40853 -5.4338 -5843 4 28.3717 37.2982 38.474 -12.8547 4.6316 9.68073 -5844 6 4.87585 1.47991 27.5772 1.0193 4.57332 -1.4391 -5845 4 5.21258 1.06654 26.7686 1.92757 2.57678 7.5628 -5846 4 5.62617 1.67061 28.1638 -3.61661 -2.55781 -2.1886 -5847 6 43.5959 24.3463 30.211 -19.7182 -5.92862 14.3815 -5848 4 44.3514 23.9347 29.8066 13.2495 -10.0411 -7.84874 -5849 4 42.954 23.6392 30.3929 6.93549 5.0637 -4.64144 -5850 6 33.7524 3.52358 22.9355 4.65558 -3.45748 -24.1115 -5851 4 34.2253 2.7722 22.5212 -9.10678 14.6802 11.3369 -5852 4 33.6063 4.18077 22.2154 2.29559 -11.8514 17.7295 -5853 6 19.8909 13.4517 25.3922 5.25873 -5.74859 -7.9771 -5854 4 20.5096 14.0736 25.7535 5.66529 16.002 2.33546 -5855 4 19.9521 12.7313 26.0185 -3.34295 -15.2779 0.0169051 -5856 6 47.3737 23.1767 39.6212 -5.95621 11.0118 4.46955 -5857 4 47.7191 22.5265 39.0041 4.75348 -8.18234 -7.77672 -5858 4 47.7813 24.0201 39.3891 1.84918 -0.94156 0.213564 -5859 6 20.1771 18.6734 32.3906 -2.68035 -24.6067 18.319 -5860 4 19.7167 19.3347 31.8914 0.274713 15.8779 -14.5216 -5861 4 21.1289 18.7867 32.3383 1.39014 4.37005 -4.23212 -5862 6 0.462706 5.80795 25.6713 -7.84599 -7.21428 -45.242 -5863 4 0.323825 6.56383 25.0471 7.25451 -11.4554 20.6165 -5864 4 0.632949 6.14438 26.5418 1.37183 20.4375 17.7538 -5865 6 6.87393 19.55 31.9207 -32.7339 30.668 -22.5905 -5866 4 6.24577 19.9891 32.5577 15.6688 -11.8235 -17.9631 -5867 4 6.64633 19.9665 31.0139 13.7505 -20.7976 33.8805 -5868 6 6.72837 20.2799 38.5105 -3.64262 3.78431 -13.5507 -5869 4 5.92588 20.8248 38.5086 9.85336 -2.70512 -1.72466 -5870 4 6.83039 19.9897 39.4188 -3.49896 1.12624 1.5432 -5871 6 22.0356 25.927 12.2605 -11.8373 -4.76705 -8.63625 -5872 4 21.2326 25.5939 11.7351 40.6868 7.42656 16.975 -5873 4 22.8707 25.497 11.9923 -13.8486 -7.11072 -10.1952 -5874 6 39.3057 7.93299 2.64755 -0.118713 9.42534 0.0803503 -5875 4 39.6638 8.10481 3.53463 2.86319 -1.68774 -0.268253 -5876 4 39.5974 7.06378 2.35963 5.09861 -8.7519 2.38745 -5877 6 29.9647 22.0457 34.4057 2.14844 7.25734 -28.1517 -5878 4 30.9338 21.915 34.3365 -18.2911 3.03872 -0.832433 -5879 4 29.6238 22.2503 33.4865 4.56359 -4.84177 28.516 -5880 6 37.5951 16.2788 0.369586 8.64826 -19.3515 -0.400608 -5881 4 37.1939 15.3927 0.526929 9.97291 14.3398 -5.3998 -5882 4 38.4404 16.082 41.8172 -10.5319 -0.823814 4.55326 -5883 6 11.7218 13.8845 21.8896 14.7882 -39.2126 -46.5495 -5884 4 11.9305 13.3995 21.0267 -7.58848 27.5443 23.8472 -5885 4 11.7147 13.1405 22.4934 -2.11531 -1.20748 18.2217 -5886 6 33.352 10.9238 27.6262 4.19409 14.5082 -21.7958 -5887 4 32.741 11.5866 27.2704 3.79692 -6.80494 8.02232 -5888 4 34.0591 10.8732 26.9373 -11.2958 -2.76298 18.1193 -5889 6 30.9422 36.5217 10.1011 0.546516 -38.0529 -7.53065 -5890 4 31.037 36.4313 9.10316 -3.7795 -1.86296 33.6151 -5891 4 30.9555 35.5897 10.5034 1.2522 32.9448 -19.5962 -5892 6 45.5828 6.56917 25.2425 13.4794 -38.3135 -0.0969536 -5893 4 44.6735 6.51564 25.4913 -20.1668 12.9455 3.79285 -5894 4 45.8221 5.605 25.2656 2.31227 28.4662 -4.04899 -5895 6 9.53612 30.0233 12.041 13.8898 -20.9008 -19.4413 -5896 4 9.92894 30.5763 11.3437 -1.97905 0.820167 2.98642 -5897 4 9.13364 30.6129 12.6538 -15.721 17.9312 16.9413 -5898 6 53.0747 24.9738 1.38132 -1.86355 2.7084 19.7503 -5899 4 52.7154 24.2509 0.898374 -13.0694 -24.4059 -9.99565 -5900 4 53.2522 25.5795 0.686793 9.94881 23.634 -11.856 -5901 6 26.1984 24.7352 0.509304 -7.53082 -0.727442 -26.3589 -5902 4 25.609 24.783 41.6367 17.1237 -12.5609 6.929 -5903 4 25.7967 25.3842 1.06587 -1.32139 13.3231 25.2347 -5904 6 23.0109 2.41889 11.5345 -1.81733 -0.917938 -19.7561 -5905 4 22.156 2.16845 11.9124 1.98231 0.963836 1.10425 -5906 4 22.831 2.471 10.5696 1.38956 0.195961 11.1121 -5907 6 29.9165 12.8947 31.0013 41.0722 8.15666 -12.068 -5908 4 30.8272 12.8901 31.3843 -23.6061 -3.22469 3.62361 -5909 4 30.1671 13.0589 30.0659 -21.5099 -4.3955 11.2257 -5910 6 24.0423 16.1922 40.3682 -11.7161 -52.7791 -12.7633 -5911 4 23.7963 16.7427 41.0863 -4.03022 37.1909 22.8519 -5912 4 24.4513 16.6836 39.6566 3.29428 17.0417 2.56802 -5913 6 21.8759 29.9137 12.7377 16.7673 9.38207 5.68416 -5914 4 21.0615 29.603 12.3447 -12.732 2.54077 -5.12984 -5915 4 21.8572 30.8889 12.7388 -3.49843 -10.2696 0.0943897 -5916 6 45.2049 12.2865 6.6319 2.92472 30.2037 5.62675 -5917 4 45.4908 11.5347 6.14771 0.0808414 -27.1796 -10.0093 -5918 4 45.9331 12.9133 6.49804 -8.49251 3.31449 4.74769 -5919 6 7.58748 25.3948 38.035 37.4402 -5.69153 16.1754 -5920 4 8.20159 25.1941 37.2709 -20.479 6.14302 24.9331 -5921 4 8.13335 25.2556 38.8857 -20.6102 5.92378 -35.7711 -5922 6 46.1732 7.83303 16.6988 4.4841 14.5494 -17.535 -5923 4 46.5452 7.84101 15.8027 -9.24205 10.2202 -0.760543 -5924 4 46.6945 7.14485 17.0776 9.771 -19.5689 22.069 -5925 6 54.9675 12.85 7.71106 -14.5426 11.3809 9.40253 -5926 4 54.9732 13.8139 7.75484 8.59467 -0.566973 -8.90089 -5927 4 54.3786 12.658 8.45528 8.25441 -10.7611 -5.52346 -5928 6 26.93 39.6729 37.1759 35.4319 -17.0193 24.0328 -5929 4 27.7049 39.4447 36.6239 -16.3058 8.04164 -6.8945 -5930 4 27.2164 39.2553 38.0316 -23.1866 12.5553 -17.3208 -5931 6 27.0277 8.92497 38.0115 25.8258 -15.1538 -19.4143 -5932 4 26.3205 9.53863 38.1727 -14.2244 17.8778 -0.0983549 -5933 4 27.5327 9.26244 37.2322 -14.307 -2.33761 14.5508 -5934 6 8.04621 7.65921 29.9125 5.96085 -8.8046 12.0925 -5935 4 8.66182 7.92407 30.6202 -6.26406 -0.422529 -8.96361 -5936 4 7.80891 8.46925 29.4702 -0.676119 14.2 -7.80782 -5937 6 27.8751 27.8625 12.1001 -31.3933 22.4686 19.454 -5938 4 27.5095 28.719 12.4446 7.36494 -19.3603 -4.77408 -5939 4 28.6439 28.079 11.5991 25.5597 3.40516 -15.3306 -5940 6 23.5464 30.4867 38.1533 -1.61625 -6.62341 9.61758 -5941 4 24.0833 30.8354 38.8715 -5.37174 -4.61911 9.80189 -5942 4 23.9933 30.8636 37.4157 3.53805 3.96797 -22.0348 -5943 6 48.0805 24.2983 17.323 -13.282 16.609 -1.2587 -5944 4 47.4189 24.8263 17.8481 20.4082 -10.1323 -14.146 -5945 4 48.1392 24.7467 16.448 -1.93384 -6.90404 13.1726 -5946 6 38.5137 5.30503 40.3397 -7.95418 19.3032 15.6478 -5947 4 38.8605 4.51762 39.8919 14.9068 5.60332 0.485922 -5948 4 39.0782 6.12858 40.3573 -2.94219 -25.5867 -8.28862 -5949 6 31.2334 3.92786 33.7298 9.31662 9.08835 -13.8199 -5950 4 31.8178 4.24357 33.0198 -6.00608 1.6224 5.38661 -5951 4 31.5957 3.05883 33.9262 -1.57661 -10.2527 7.73336 -5952 6 41.2417 8.81323 38.1247 -0.484904 -12.0607 11.4744 -5953 4 40.9476 8.42023 38.9721 -0.376638 9.54125 -7.13918 -5954 4 41.2604 9.77162 38.2616 1.58028 -2.03482 4.89657 -5955 6 53.3602 29.1001 24.587 -11.0956 7.72569 2.80506 -5956 4 52.5731 28.5594 24.8544 13.5868 20.3826 -7.54714 -5957 4 53.0545 29.9696 24.221 1.09296 -21.6534 7.27768 -5958 6 54.9204 15.5334 40.7094 -9.73888 -15.8123 9.62316 -5959 4 54.8689 16.4143 40.4003 18.499 35.235 -15.9181 -5960 4 53.9936 15.418 40.9228 -4.36807 -19.1537 6.40504 -5961 6 46.4046 17.0769 31.8825 -4.88415 8.61979 -0.317809 -5962 4 46.5643 17.9902 31.5503 -4.54791 -14.0743 0.407713 -5963 4 45.6863 16.6828 31.3336 12.87 12.2001 8.08584 -5964 6 36.9136 25.0502 23.0508 4.56287 5.14957 -21.3849 -5965 4 37.1181 25.0639 23.9643 8.53293 7.7605 31.6671 -5966 4 36.2092 24.4176 22.9617 -10.0712 -5.98832 -5.36051 -5967 6 11.3786 4.43396 15.9309 9.37238 17.2608 -3.05203 -5968 4 11.3458 3.5794 15.4688 2.43716 9.1998 0.97888 -5969 4 11.7026 5.12247 15.2999 -5.70859 -16.4138 5.77914 -5970 6 12.7896 7.06818 19.4525 -2.66824 36.6483 10.7184 -5971 4 12.9865 6.29411 18.9417 0.495259 -24.323 -4.17525 -5972 4 12.2519 6.828 20.2299 7.04203 -8.59773 -13.3487 -5973 6 12.0617 33.6499 17.5439 8.15138 -13.8576 -23.5514 -5974 4 11.882 34.0654 18.3682 -11.1792 16.7137 24.4072 -5975 4 12.5902 32.8825 17.8108 -1.08307 -0.300652 -3.52071 -5976 6 10.2421 4.75805 2.56564 19.3085 -11.8452 1.86691 -5977 4 9.45693 4.42703 2.99801 -10.4664 -1.42643 2.59081 -5978 4 10.9264 4.04527 2.68225 -6.18235 16.1727 -3.70264 -5979 6 4.57251 36.8735 12.1563 3.74049 -23.6741 -21.1206 -5980 4 4.47996 37.7154 12.5491 -11.9533 34.2042 20.255 -5981 4 5.43811 36.9355 11.7449 0.921031 -10.3689 -0.351167 -5982 6 30.7412 35.3317 25.8213 -33.1423 -23.543 6.44877 -5983 4 31.2776 35.279 26.6136 10.5944 3.70967 -1.00248 -5984 4 29.9668 34.7615 26.0677 13.1622 11.7399 -12.7178 -5985 6 20.1808 7.16217 1.863 30.1084 16.4868 -11.867 -5986 4 20.9002 6.54767 2.16414 -16.0511 17.5979 -8.58506 -5987 4 20.6676 7.94845 1.45686 -14.4541 -29.1822 13.3394 -5988 6 21.7608 6.89709 28.9964 -11.5861 -1.80466 -8.03013 -5989 4 22.036 7.16072 29.8728 6.26891 1.69864 13.9065 -5990 4 22.5393 6.5849 28.5353 8.83449 0.101288 -1.59126 -5991 6 6.87368 37.1369 6.9386 0.0966708 26.3677 27.0276 -5992 4 7.29364 38.0249 6.81033 -7.58004 -19.2864 -7.26696 -5993 4 6.61926 37.1727 7.88431 1.83825 -7.02501 -19.6681 -5994 6 37.1919 18.383 16.2937 29.0289 34.5069 -53.2335 -5995 4 36.6258 18.6038 17.011 -19.1901 14.6481 22.2869 -5996 4 37.3395 19.2625 15.7718 -11.4936 -34.1346 27.3139 -5997 6 52.3871 25.4845 31.3088 43.0013 26.9533 24.6388 -5998 4 52.3889 26.4071 31.692 -12.9868 -26.5619 -15.078 -5999 4 53.3562 25.2868 31.368 -25.5563 -9.18093 -7.26498 -6000 6 3.9438 39.8542 16.3866 5.1752 -27.5036 1.27902 -6001 4 3.12325 39.6837 16.8533 -2.95342 6.97088 0.658243 -6002 4 4.2268 38.9387 16.1321 1.7457 31.291 -0.663648 -6003 6 26.0576 14.6358 18.3044 5.96149 26.4073 -5.45028 -6004 4 27.0205 14.6227 18.4365 -6.17521 2.0803 0.6884 -6005 4 25.8163 15.5963 18.2277 1.60591 -22.5499 1.70317 -6006 6 22.193 39.6312 23.63 -9.05536 -28.9999 9.83005 -6007 4 22.6639 40.3889 23.3083 10.2118 22.7493 1.36107 -6008 4 21.7625 39.8434 24.4837 8.53947 8.47814 -10.8223 -6009 6 5.99591 12.8758 22.3742 5.3436 -0.661706 -0.190442 -6010 4 6.14325 13.1833 21.4713 -0.679137 1.38292 -0.893953 -6011 4 6.87425 12.6139 22.6767 3.78948 -2.07704 1.05968 -6012 6 48.9338 28.1628 34.7078 -35.8712 26.2385 4.15493 -6013 4 48.201 27.5556 34.4701 19.6025 -0.265843 1.21851 -6014 4 49.8217 27.8183 34.7001 12.2446 -20.4038 -3.75147 -6015 6 7.76997 22.4407 33.2353 -5.03116 -11.9457 7.57841 -6016 4 8.01899 22.0009 34.0594 5.33952 7.11928 -2.86974 -6017 4 7.10669 21.8538 32.8613 -1.17853 4.26119 -2.40878 -6018 6 41.0955 39.6222 11.7091 10.6381 -27.5326 3.52715 -6019 4 40.5189 40.2602 11.288 0.0449404 21.7474 -0.525631 -6020 4 41.8612 39.9918 12.1934 -14.1016 15.1893 -9.59654 -6021 6 26.8828 37.915 39.359 -2.28209 0.567193 11.8658 -6022 4 27.0774 38.1179 40.3058 -8.7685 -4.90824 -13.677 -6023 4 25.9807 37.5277 39.3071 12.6176 5.79057 5.20946 -6024 6 16.8333 41.5427 16.7885 -17.5694 -7.84814 -1.75502 -6025 4 17.5277 0.148354 16.3589 5.69783 -2.62712 11.3029 -6026 4 16.9979 41.3393 17.726 8.37907 5.88226 -10.2657 -6027 6 19.018 8.99657 17.6669 -0.857073 -13.2853 32.8939 -6028 4 18.786 9.90902 17.9004 1.19423 -0.949069 -3.8378 -6029 4 19.1413 8.47286 18.5173 -2.13518 15.132 -32.6231 -6030 6 31.1034 24.3848 20.0884 -4.53251 11.7336 -2.81937 -6031 4 30.5766 24.6463 20.8643 6.13742 -4.20791 -6.36966 -6032 4 31.7352 25.0989 19.9557 0.422515 0.146513 0.562515 -6033 6 24.595 6.30881 27.6069 -9.90555 -11.0232 -14.6341 -6034 4 24.6965 6.6392 26.7007 0.89989 8.76246 8.56835 -6035 4 24.5083 5.35606 27.4824 0.344086 -1.65377 9.53776 -6036 6 11.6335 5.32908 8.21523 29.3959 14.5761 -12.3078 -6037 4 10.744 5.12885 8.4339 -32.4949 -9.42488 11.9016 -6038 4 11.5648 6.10082 7.62627 0.276207 -9.77668 5.48929 -6039 6 16.478 34.2375 17.2464 48.0037 -1.61779 7.84119 -6040 4 15.7306 34.6529 16.8034 2.48832 11.605 -8.49411 -6041 4 17.405 34.6677 17.061 -56.7063 -17.2336 2.19282 -6042 6 40.7477 40.4696 8.51561 8.11488 -8.65224 -15.2287 -6043 4 40.0224 40.6832 9.09702 -8.50867 2.70994 6.70857 -6044 4 40.4514 39.6579 8.0617 2.3787 8.8385 5.97324 -6045 6 42.7444 5.87231 14.2984 24.2128 7.61876 -1.56509 -6046 4 42.0757 5.96647 14.9632 -14.4615 -1.80987 8.42029 -6047 4 42.482 5.17586 13.6922 -11.2697 -3.69634 -0.0191913 -6048 6 14.3614 21.0573 6.06698 -40.3301 2.02826 20.3099 -6049 4 14.5082 21.6099 6.85229 1.25225 -5.13952 -5.68983 -6050 4 15.1941 20.9025 5.67555 35.2665 -1.55979 -15.977 -6051 6 16.3015 37.7733 18.121 -25.7671 9.10936 -15.4408 -6052 4 15.381 38.1761 18.2458 41.2545 -15.1679 7.93486 -6053 4 16.7788 37.6858 18.9587 -11.1023 5.71932 1.62274 -6054 6 40.7984 27.7161 27.1129 -11.0179 0.499807 -0.336913 -6055 4 41.4742 27.2927 27.66 5.56711 1.79851 -1.75817 -6056 4 41.2133 28.334 26.4954 6.67104 -1.0644 4.19578 -6057 6 44.9561 25.991 14.0487 25.7727 -16.7938 -19.0088 -6058 4 45.3739 25.1637 13.7108 -16.5098 12.8855 15.8726 -6059 4 45.5476 26.6442 13.6478 -7.0093 2.51014 3.36733 -6060 6 2.61494 33.9473 21.2474 -9.6198 2.06317 -4.83635 -6061 4 2.13704 34.7904 21.3802 4.44423 -7.12162 -0.559399 -6062 4 2.10703 33.4352 20.5879 2.52794 8.8644 7.26413 -6063 6 5.77575 4.45209 12.8318 1.03208 18.7287 8.08797 -6064 4 5.35339 3.69685 13.2518 -3.06112 -10.1665 -2.69945 -6065 4 5.8052 5.15326 13.507 0.887863 -7.02627 -5.52828 -6066 6 16.8649 5.92112 7.40874 19.9951 -5.29142 4.66315 -6067 4 16.4994 5.07825 7.12483 -4.58221 -9.71617 -5.56506 -6068 4 16.109 6.48147 7.52662 -16.4719 8.95214 3.19539 -6069 6 17.8298 38.4233 36.8534 9.258 40.3096 -0.310058 -6070 4 17.7926 39.4131 36.8935 -6.04129 -19.7424 1.84578 -6071 4 18.5177 38.2893 36.201 1.93535 -10.8086 -1.92368 -6072 6 43.3019 20.5959 5.44166 -6.9278 5.85438 -3.52603 -6073 4 43.1055 21.501 5.07158 -2.97833 -26.833 8.04502 -6074 4 42.4661 20.0651 5.41852 11.3272 16.2867 -2.99003 -6075 6 21.5372 23.2991 30.4448 -14.935 11.2275 -26.3705 -6076 4 20.9947 23.0537 31.1809 -7.12546 -6.28648 20.8256 -6077 4 20.8648 23.582 29.7655 22.6032 -4.28693 10.3415 -6078 6 0.251317 28.0486 36.1651 -22.0243 21.0356 -19.5016 -6079 4 1.02049 27.7114 36.6113 18.9729 -1.47718 6.47801 -6080 4 0.506474 28.8456 35.6445 2.58205 -12.8812 9.00708 -6081 6 3.04678 17.0589 11.5707 1.23946 -7.00965 -18.5436 -6082 4 3.14519 17.2619 12.4977 -1.89892 8.1653 13.6088 -6083 4 2.54959 17.7766 11.1613 1.73961 1.36316 5.23635 -6084 6 24.1645 37.0333 23.9496 -13.0802 10.7124 17.6799 -6085 4 23.6099 37.8384 23.8849 6.1763 -9.33563 -1.28122 -6086 4 24.4663 37.0147 24.8893 -3.58635 -1.49958 -18.3056 -6087 6 3.94341 20.5209 27.4789 6.12038 36.4957 26.1587 -6088 4 3.64002 20.0757 26.7101 -13.0247 -10.3927 -30.3524 -6089 4 3.8213 21.4921 27.3096 0.6263 -21.942 -1.90407 -6090 6 54.8381 2.78983 29.6272 25.3782 12.002 29.7256 -6091 4 54.8259 2.49183 30.5832 -3.08894 8.50949 -25.0172 -6092 4 0.681738 3.33643 29.5869 -23.0163 -14.7319 0.890579 -6093 6 27.1738 8.43221 31.7209 4.37325 44.8318 10.1666 -6094 4 26.7765 8.21235 30.8513 3.34031 12.9925 0.247925 -6095 4 27.4394 9.43578 31.8184 -18.7706 -51.1708 -12.8964 -6096 6 30.9422 1.62815 30.3909 7.68258 9.19266 14.5116 -6097 4 30.6848 0.902997 29.8247 -17.6873 -14.6962 -9.63211 -6098 4 30.1385 1.96768 30.8202 -2.70664 -9.08975 -4.26502 -6099 6 26.4126 36.4396 36.8407 14.7094 2.78685 2.16538 -6100 4 26.1754 35.936 36.0621 -1.37556 -1.6634 -9.1832 -6101 4 27.3614 36.6667 36.7609 -11.9856 -2.56278 0.470716 -6102 6 51.3051 10.055 21.7064 16.9271 -12.7171 -0.47742 -6103 4 50.71 9.38094 22.0984 13.3581 11.7028 -6.50503 -6104 4 52.1297 9.58932 21.3894 -28.6693 12.5934 9.83408 -6105 6 52.4269 12.3712 23.2743 -6.4707 23.0639 13.1163 -6106 4 51.7645 13.1043 23.2119 13.6159 -11.3613 1.42096 -6107 4 52.024 11.6223 22.842 -6.69009 -13.0182 -9.76131 -6108 6 10.0084 38.37 20.6075 21.9453 -2.41338 -4.30271 -6109 4 9.45069 38.2813 21.3825 -6.19229 -0.201962 6.85596 -6110 4 10.9137 38.1225 20.8794 -8.5598 0.614521 -3.9406 -6111 6 22.7031 33.2664 0.640708 10.9794 6.62646 4.85135 -6112 4 23.6679 33.2996 0.582378 1.56947 7.5672 2.73741 -6113 4 22.5144 32.4288 0.230474 -14.5468 -15.5809 -6.04383 -6114 6 14.0917 40.8812 25.4864 9.18744 8.89463 -14.7226 -6115 4 14.196 40.6884 26.4283 -5.63746 -5.20078 0.271339 -6116 4 13.2439 40.5125 25.1796 5.27736 1.6069 9.18822 -6117 6 42.7681 15.0783 14.9763 7.15748 5.71054 -2.59845 -6118 4 43.0785 15.7158 14.2901 -5.10451 -16.9901 16.8665 -6119 4 41.8327 15.2592 15.1092 -5.54173 -0.124331 1.80857 -6120 6 30.2406 7.22111 8.53832 -0.545825 26.9265 -4.64375 -6121 4 30.1758 8.19473 8.52708 -1.1145 -9.52086 -16.9196 -6122 4 30.4024 7.07989 9.45321 5.06633 -17.0605 24.2519 -6123 6 3.37759 19.8423 41.3077 23.4194 0.89426 -0.123069 -6124 4 3.19865 19.3681 40.4829 0.842743 3.23829 1.04749 -6125 4 4.34953 20.0012 41.2688 -20.407 -4.57585 2.1738 -6126 6 8.87423 25.1354 17.2017 -10.0567 -4.23249 -18.7298 -6127 4 8.96932 24.947 16.2256 5.94886 2.92938 28.6011 -6128 4 9.65182 24.8278 17.6915 0.0257745 -5.63434 -9.64419 -6129 6 9.32494 14.9555 22.0283 -12.5325 4.5599 7.62514 -6130 4 9.01993 14.8718 22.9489 -0.27625 1.365 -7.1979 -6131 4 10.1958 14.5523 22.0148 2.38734 -2.44115 -2.54227 -6132 6 2.03086 4.7751 20.8592 -0.302533 -25.5342 -8.8148 -6133 4 2.76807 5.37577 20.9697 7.90436 11.3601 5.00545 -6134 4 1.2576 5.15949 21.2703 -7.54078 11.376 6.7073 -6135 6 18.2964 7.06718 3.86051 -0.633466 1.54328 39.8902 -6136 4 18.916 7.22135 3.16498 20.2468 5.35447 -22.1173 -6137 4 18.8081 6.54637 4.52758 -12.8964 10.087 -8.61721 -6138 6 17.0178 19.1734 19.8425 8.05121 8.342 4.19715 -6139 4 17.786 18.9037 19.3194 -9.06534 -4.96345 -2.22737 -6140 4 16.269 18.585 19.6427 11.1227 0.819232 -3.01639 -6141 6 4.30363 6.55267 21.3463 7.67654 -0.43578 -3.38259 -6142 4 4.33009 7.06923 20.5107 4.36212 -5.74714 10.2686 -6143 4 5.22777 6.26626 21.5669 -20.6993 9.2157 -12.5452 -6144 6 20.7848 36.9284 35.662 4.03453 1.95325 3.7669 -6145 4 20.2254 37.0836 34.8976 -2.25577 1.87165 -3.27163 -6146 4 20.2383 36.4327 36.2875 0.848364 -0.11832 4.44878 -6147 6 4.7306 15.0205 31.2333 -1.91968 -20.8619 8.65585 -6148 4 4.4229 14.7734 32.1398 6.18773 10.2906 -17.1472 -6149 4 4.73385 15.973 31.1263 -2.35963 8.87481 4.31723 -6150 6 2.35358 1.22877 17.5767 10.9459 -8.92502 -6.22121 -6151 4 3.05741 1.28614 16.8672 -19.772 5.07478 19.7417 -6152 4 1.94409 2.09607 17.7592 7.86728 -5.07336 -5.26938 -6153 6 34.6221 31.5613 19.8029 0.0167231 -1.91103 -0.857839 -6154 4 35.0026 31.8698 18.9629 1.12657 -3.13716 4.28436 -6155 4 34.4223 32.3623 20.3103 -0.485441 0.265221 -3.01806 -6156 6 24.1912 21.6103 13.5173 31.6251 8.72647 13.7111 -6157 4 25.0921 21.8731 13.8418 -25.6554 -7.43575 -12.369 -6158 4 23.5893 22.1875 13.984 -2.65104 7.77201 2.87587 -6159 6 37.2187 41.0834 5.69361 1.76676 -13.0415 -0.936073 -6160 4 37.8761 41.7354 5.91144 16.7665 3.57334 0.125879 -6161 4 36.4089 41.5349 5.88363 -19.4064 5.82624 -1.33385 -6162 6 8.4323 8.00063 20.2395 28.2224 -17.334 -6.20124 -6163 4 9.29892 8.115 20.6547 2.73811 -3.60152 -0.447724 -6164 4 7.94828 8.69862 20.6224 -29.3938 29.4062 12.6481 -6165 6 14.9357 18.8843 36.7618 11.8158 33.7978 0.271425 -6166 4 14.1259 19.2123 36.362 -3.40669 -6.42507 -0.135577 -6167 4 15.5651 19.6361 36.6422 -7.52364 -17.7077 5.06346 -6168 6 43.9725 40.6444 18.6569 4.16672 -2.33153 16.0012 -6169 4 43.9166 40.834 17.7203 0.682613 4.51617 -13.4207 -6170 4 44.9212 40.6761 18.9032 -12.0211 -3.47257 -3.21486 -6171 6 33.7852 32.2494 37.3449 -11.8504 2.76306 -14.1758 -6172 4 34.0177 32.2775 36.4055 -1.41242 -0.232407 11.1732 -6173 4 34.3686 31.6236 37.7745 10.7747 -2.06792 3.13276 -6174 6 5.09749 29.2901 24.0356 16.7213 -6.5526 19.7529 -6175 4 5.77222 29.487 24.7328 -11.5239 -2.29901 -14.2657 -6176 4 4.7684 30.1321 23.7215 -1.73734 11.0072 -2.10513 -6177 6 33.6153 36.4198 10.9805 1.47517 3.52666 5.33615 -6178 4 32.7579 36.4403 10.5596 -3.06779 3.10292 -7.60642 -6179 4 33.384 36.4828 11.91 5.71512 -0.747971 7.16991 -6180 6 28.3006 33.5952 13.1115 6.62888 -15.4249 13.7129 -6181 4 27.948 33.7778 12.2398 -4.56551 -8.24283 -4.77521 -6182 4 28.1705 32.6462 13.2914 -0.364449 12.3294 -7.26248 -6183 6 6.16378 19.058 24.2919 3.99573 -9.29146 -27.7059 -6184 4 6.01812 19.825 24.8144 -3.49512 27.1397 16.8881 -6185 4 6.29927 18.3335 24.8859 3.7649 -20.2974 16.0908 -6186 6 28.4267 19.9356 1.8581 6.30761 1.98196 1.30153 -6187 4 28.5945 19.3745 1.10227 -2.74725 -9.675 -9.29711 -6188 4 29.2893 20.1184 2.23075 1.76934 5.71608 2.57016 -6189 6 42.0557 23.969 9.55925 -0.174378 -1.97525 4.49576 -6190 4 42.3037 23.8044 10.4694 5.92504 9.79373 11.5418 -6191 4 41.7282 23.1152 9.29053 -8.19873 -12.6145 -11.7634 -6192 6 43.5187 7.30226 27.4319 7.08124 -12.3985 0.368771 -6193 4 42.7424 7.14751 27.9838 -5.23639 1.01312 3.8871 -6194 4 43.2552 7.97753 26.8025 -4.71413 8.37143 -8.21745 -6195 6 20.4824 33.0041 9.27291 -32.573 -27.3267 34.6611 -6196 4 19.7824 32.5876 9.93875 35.2414 32.5831 -36.6535 -6197 4 20.3431 33.9616 9.1663 -10.2228 -2.75758 9.24016 -6198 6 38.0326 35.2526 15.9362 -7.94884 -19.6622 -5.99631 -6199 4 37.3459 34.9971 15.2894 4.63074 2.95951 5.93375 -6200 4 37.9463 34.6017 16.6504 2.45283 5.99568 -2.76115 -6201 6 47.5301 20.8853 3.96175 -5.34824 -5.66637 20.3565 -6202 4 47.9759 21.3648 3.2498 -4.9297 7.97101 8.48596 -6203 4 47.5029 21.3928 4.81786 6.75175 -1.3172 -26.6206 -6204 6 10.9933 31.6966 41.4271 11.47 5.02521 -0.853614 -6205 4 11.6392 31.7665 40.7132 0.112137 -5.28149 3.10577 -6206 4 10.1353 31.6993 40.998 -8.62143 -0.203152 -1.66696 -6207 6 43.2403 12.6562 2.57215 9.62694 -8.68348 -18.5989 -6208 4 42.9077 12.993 3.39384 -2.38679 2.43178 19.528 -6209 4 44.033 12.1261 2.78242 -8.9232 8.2725 3.71991 -6210 6 49.4204 25.4105 21.1683 5.59269 -12.2048 -2.72561 -6211 4 50.0196 25.2987 20.4097 -7.64964 4.29225 2.01473 -6212 4 48.8877 24.5919 21.195 1.69169 7.44836 1.02425 -6213 6 1.95674 34.1403 26.4747 8.8762 -24.2704 6.47661 -6214 4 2.77674 33.6103 26.5537 -12.4269 14.6955 -4.62849 -6215 4 1.26657 33.4613 26.3994 -1.21739 9.31774 -1.03397 -6216 6 17.1306 20.8229 36.6851 -31.9931 14.1441 13.8122 -6217 4 16.9533 21.7471 36.9985 5.62896 -19.6931 -5.93312 -6218 4 18.0634 20.696 36.5868 23.783 -2.64609 -3.70934 -6219 6 36.6048 10.9866 3.71548 -5.44552 8.31799 24.2539 -6220 4 35.7423 11.3886 3.87785 -5.6936 5.55042 -13.8219 -6221 4 36.8135 10.7077 4.61447 10.9535 -7.59336 -0.361553 -6222 6 14.2169 20.6838 21.9439 11.6961 23.12 -6.3106 -6223 4 13.8085 20.2376 21.1912 1.98746 8.13024 -7.83415 -6224 4 14.8103 21.4259 21.6461 -14.674 -27.097 -1.82439 -6225 6 33.9151 12.2544 9.54899 39.8857 -26.0408 -21.0892 -6226 4 34.3088 11.5163 10.0208 11.0461 -3.70138 -11.6499 -6227 4 33.2997 12.4814 10.1903 -47.9458 31.9244 32.2008 -6228 6 21.8056 41.4836 2.15686 0.64336 -1.87746 -8.80618 -6229 4 22.0354 41.6672 1.22189 -5.57638 1.91412 12.8342 -6230 4 22.5122 40.9391 2.50884 5.16687 -0.375256 0.644554 -6231 6 20.9282 10.4547 14.1996 25.019 -0.0729632 25.5582 -6232 4 21.5922 10.842 14.8375 -21.0894 -6.80718 -21.5316 -6233 4 20.826 9.54084 14.5456 -0.887825 12.9084 -9.51249 -6234 6 6.24616 4.45231 24.6293 -10.9468 0.993291 2.39826 -6235 4 6.83688 4.17894 23.9311 12.242 -0.137787 -14.9911 -6236 4 5.68087 3.68408 24.7586 -3.59028 -1.51582 -1.5433 -6237 6 50.784 14.5954 23.4824 21.8736 9.84292 5.60122 -6238 4 51.2681 15.1205 24.1582 -9.03857 -7.6656 -10.4761 -6239 4 49.9341 14.3608 23.8519 -7.60536 -4.54693 6.65168 -6240 6 52.7678 13.9144 9.68214 -3.90955 36.1598 -0.40974 -6241 4 52.8738 13.0144 9.92216 4.47335 -34.5538 7.53363 -6242 4 51.8729 14.0092 9.35938 -14.036 0.105332 -6.17221 -6243 6 9.05048 2.05234 29.9152 -29.3842 -12.1538 -14.6176 -6244 4 9.42756 2.83336 30.2687 13.3628 24.1087 13.7335 -6245 4 8.09173 2.26823 29.8032 18.9866 -6.39081 0.174186 -6246 6 7.13499 29.9757 26.2377 7.52656 -33.046 2.78556 -6247 4 6.52748 30.39 26.8607 -0.20976 -1.88395 4.87081 -6248 4 7.49713 29.1538 26.6869 -11.4544 24.9502 -11.4644 -6249 6 49.1541 41.742 14.3355 11.4439 21.5488 -10.6063 -6250 4 49.5333 41.2573 13.5835 -2.72613 -5.13007 3.47372 -6251 4 49.526 0.750494 14.2401 -8.50163 -23.9907 2.80869 -6252 6 5.64545 3.82333 19.1929 -5.43924 -10.1162 19.2647 -6253 4 5.12472 3.39384 19.906 6.51959 7.46947 -11.8792 -6254 4 5.07872 3.8651 18.4273 -3.31865 2.78603 -7.74707 -6255 6 9.32747 35.8381 24.9081 -3.67476 7.0144 6.61099 -6256 4 10.2167 35.7622 24.5243 -1.5306 1.39279 3.84516 -6257 4 9.42305 36.4736 25.6393 1.10498 -0.920313 -3.33942 -6258 6 53.0258 29.7567 11.5493 -1.29773 -2.97991 8.71205 -6259 4 53.4398 30.4104 10.9769 2.6525 4.63524 -3.89524 -6260 4 52.8324 30.2122 12.386 1.27544 -1.91261 -4.55584 -6261 6 22.6082 9.97702 5.69106 1.45951 -2.04334 43.7981 -6262 4 23.4598 10.2484 6.09617 -7.85329 -3.83944 -13.5574 -6263 4 22.5497 10.2693 4.79236 2.60512 5.60546 -21.7219 -6264 6 39.5532 19.6216 2.68726 -3.50035 -14.5445 -22.3968 -6265 4 38.6563 19.3067 2.54039 -1.65167 0.121811 17.9309 -6266 4 39.9003 19.405 1.80953 18.3116 7.78412 6.67062 -6267 6 45.082 35.5833 7.81025 20.3465 -2.3491 -25.2688 -6268 4 45.1219 36.3229 8.40611 -5.73741 11.9797 15.8104 -6269 4 44.452 34.9332 8.12016 -12.4923 -3.86067 9.83054 -6270 6 29.7976 14.244 9.96067 -5.32248 -4.64296 1.12628 -6271 4 30.0443 14.0971 9.02808 -4.18819 -1.64606 2.67632 -6272 4 28.8444 14.0269 10.0606 18.5465 4.64021 -4.02524 -6273 6 29.2523 30.155 21.8932 -5.77992 6.30922 3.94049 -6274 4 29.1431 30.8143 21.21 -7.42967 10.4849 -3.0507 -6275 4 30.0153 29.6632 21.6201 11.6336 -14.2167 -2.13367 -6276 6 11.1107 18.8213 6.56056 -14.6836 -1.88929 0.635516 -6277 4 11.166 19.7501 6.27543 7.98891 -2.6539 -0.194038 -6278 4 11.9915 18.4225 6.59495 6.41359 9.14832 -2.51569 -6279 6 13.4142 39.1371 13.4638 17.7807 -10.3765 -23.6259 -6280 4 13.7831 39.7975 14.0449 5.16656 9.87024 9.85065 -6281 4 12.6066 38.8468 13.8734 -16.0883 -5.26763 6.93978 -6282 6 50.1521 12.9948 0.13749 23.7903 11.3983 42.7862 -6283 4 49.8531 12.6437 41.2486 -17.3674 -16.2897 -43.7514 -6284 4 50.6811 12.2823 0.528204 -2.61001 5.26075 1.59628 -6285 6 47.8279 31.3538 27.7873 0.535952 -14.579 -21.2406 -6286 4 47.8981 31.8966 28.5732 -11.876 9.28639 5.42067 -6287 4 46.9879 31.5201 27.3031 12.1261 3.81279 14.9113 -6288 6 27.708 1.63283 7.49454 14.1634 -3.44528 -21.3886 -6289 4 26.9442 1.71926 8.04828 -16.4795 3.87106 10.0363 -6290 4 27.4331 1.03137 6.77318 -2.44435 3.14912 6.58235 -6291 6 54.8843 20.7912 16.041 -0.591057 -23.5277 -19.4313 -6292 4 54.9506 20.9946 16.9763 2.49267 -3.51754 11.2958 -6293 4 0.215527 19.8591 15.8725 -6.64294 24.8159 10.1677 -6294 6 37.4309 32.9919 34.4461 -3.01999 17.5498 0.613574 -6295 4 37.2599 32.074 34.6492 -8.98721 -14.1314 1.69718 -6296 4 36.602 33.3843 34.0789 10.8556 -9.90957 7.57788 -6297 6 19.516 39.775 6.74949 1.2991 -23.719 -0.568837 -6298 4 19.1628 39.2461 5.9771 11.6696 10.1577 21.4746 -6299 4 19.8715 39.1258 7.41882 -10.6166 14.587 -19.1486 -6300 6 32.439 2.74298 8.0597 2.15016 14.1028 28.0311 -6301 4 32.8474 3.04427 8.91221 -2.20578 -4.83758 -21.9226 -6302 4 31.6043 2.37221 8.38063 -2.27075 -4.50389 -9.9889 -6303 6 12.9757 16.0783 4.05517 0.782156 -17.4841 -11.0101 -6304 4 12.5393 15.6612 4.81952 2.97976 0.136191 -5.67644 -6305 4 13.3707 15.3387 3.55371 -3.64889 7.0956 8.52646 -6306 6 4.65115 29.9533 5.41887 4.80886 14.2508 -32.4371 -6307 4 5.0407 30.2031 4.52094 -17.5959 -12.1853 28.663 -6308 4 3.95879 29.263 5.26663 23.43 17.9812 0.878069 -6309 6 29.754 32.1152 24.0535 7.2798 7.01713 3.37681 -6310 4 30.6602 32.1649 24.4187 -11.1956 -0.828668 -6.39664 -6311 4 29.7572 31.4388 23.3746 -2.03067 -7.97912 -3.55015 -6312 6 11.8649 30.6972 33.4692 4.66278 -43.8766 26.3819 -6313 4 11.8723 29.8544 34.0435 -6.78391 38.5593 -23.2698 -6314 4 12.7601 30.7129 33.1118 -0.162199 2.5806 0.32685 -6315 6 17.3589 40.4121 27.3072 22.6925 26.1242 -9.80885 -6316 4 17.3318 41.3765 27.4299 10.8839 -2.3351 -5.50809 -6317 4 16.5554 40.1462 27.6883 -41.5002 -17.3681 16.6281 -6318 6 8.67113 4.89706 8.92484 12.0335 -9.87957 -4.1983 -6319 4 8.33733 5.39218 8.1724 -5.0195 2.6367 -1.72337 -6320 4 8.22391 5.22927 9.70847 -2.49168 4.71619 2.25155 -6321 6 39.5722 17.6819 9.57834 18.7012 -23.4437 -36.958 -6322 4 39.2207 17.6668 10.4653 -7.32211 -9.11094 11.7967 -6323 4 39.6226 16.7555 9.16114 -8.90732 35.1542 21.3272 -6324 6 31.4906 30.1663 28.5669 -18.2413 -3.40307 10.1233 -6325 4 32.2933 30.4252 28.099 2.93126 -8.695 5.25695 -6326 4 31.6493 29.3506 29.0723 8.50077 6.58979 -7.17605 -6327 6 52.667 19.2904 40.0609 -3.10376 4.72625 -3.48654 -6328 4 52.9542 18.5867 39.4362 -2.88314 13.2503 8.01058 -6329 4 53.0181 20.1618 39.7754 -0.243354 -8.89628 -7.05583 -6330 6 3.24103 7.80987 9.85575 15.4795 13.9798 -0.387217 -6331 4 3.75934 8.59525 10.1836 -13.0283 -21.6848 -11.3123 -6332 4 3.84189 7.30622 9.27659 -5.58147 6.91981 6.81825 -6333 6 23.1336 35.2172 35.587 -21.8844 -14.3383 30.559 -6334 4 23.8289 35.3646 34.9695 18.2116 12.6911 -23.5817 -6335 4 22.438 35.8962 35.5045 5.76256 0.966742 -5.52301 -6336 6 19.4997 14.0668 20.8253 -20.4482 -5.33672 -12.8711 -6337 4 19.9465 14.5101 21.5526 -0.10572 6.16799 9.82761 -6338 4 18.517 14.0876 20.9737 19.1914 1.01522 3.6393 -6339 6 23.6166 15.8675 24.0247 18.6101 -11.8924 -11.0295 -6340 4 23.7056 16.8159 24.0204 -5.88143 19.7526 4.0278 -6341 4 24.4592 15.5679 23.6279 -14.5441 0.474754 5.50536 -6342 6 0.271665 30.4941 6.10208 19.3679 10.4089 38.3983 -6343 4 55.0639 30.1609 5.24948 -13.9023 -9.5098 -30.2095 -6344 4 54.47 30.83 6.54681 -8.02886 -2.57547 -7.81581 -6345 6 4.88814 13.205 29.1223 -11.8587 -43.2127 -22.2411 -6346 4 4.78002 13.8458 29.7909 -3.08187 32.2273 31.1649 -6347 4 5.63816 13.4614 28.593 12.4558 6.3486 -8.85318 -6348 6 54.2078 27.2696 19.1963 -15.9712 -23.151 25.2067 -6349 4 0.0774591 27.3551 19.591 11.6552 0.895327 2.86932 -6350 4 54.2345 27.7605 18.3958 2.66703 17.7524 -27.3595 -6351 6 13.918 35.7451 9.18145 -1.78919 -38.7722 -17.1362 -6352 4 13.6805 34.9997 8.54227 8.11159 28.2534 18.027 -6353 4 13.9675 36.5302 8.63631 -0.993585 8.08981 -9.4946 -6354 6 5.91273 31.9181 18.8024 -12.4461 1.37758 17.74 -6355 4 5.51416 32.8097 18.9023 4.86685 -6.68339 -12.1033 -6356 4 6.30341 31.7597 17.9414 -1.0189 10.0948 -10.5031 -6357 6 5.79665 28.8753 9.48388 1.22923 1.68801 -9.18455 -6358 4 5.13151 29.3325 10.0083 -4.81051 1.68465 1.48607 -6359 4 5.29369 28.2634 8.9143 2.26517 5.17431 2.85494 -6360 6 40.1173 6.05944 9.72118 13.8961 -11.6659 -14.1698 -6361 4 40.0092 6.65032 8.94634 5.33155 -13.6 11.5113 -6362 4 40.8322 5.39707 9.49335 -23.1878 23.6737 0.508505 -6363 6 20.33 13.449 41.3936 11.1096 -0.534149 -19.18 -6364 4 21.2311 13.7006 41.7531 -26.0398 -5.61362 -19.048 -6365 4 20.2547 13.6822 40.4168 8.50391 -3.95591 26.8537 -6366 6 14.4455 21.736 27.3642 10.1345 -2.11962 18.0607 -6367 4 15.3888 21.7922 27.5976 -10.3958 0.0660495 -7.924 -6368 4 14.3649 21.6255 26.4124 4.42937 0.724974 -0.20238 -6369 6 38.7561 1.79551 30.0553 7.9914 -17.3849 -15.575 -6370 4 38.4573 2.01955 30.9195 -8.42419 6.13431 27.6354 -6371 4 38.9299 2.64677 29.6557 3.10695 8.29419 -8.65227 -6372 6 5.60526 10.8558 14.1801 -12.7318 -17.5226 5.68918 -6373 4 4.9397 11.5438 14.0518 -0.153792 0.369728 -2.18729 -6374 4 5.10481 10.0791 14.5379 11.5553 16.0131 -9.09073 -6375 6 45.3957 36.7129 27.9145 12.4213 23.5208 -28.0365 -6376 4 46.0624 36.7782 28.6036 -4.12954 -6.22049 8.27184 -6377 4 45.8092 37.2197 27.1638 -19.7894 -19.9635 17.4029 -6378 6 54.0798 35.0308 20.3994 -2.843 -1.86615 -11.5734 -6379 4 53.8804 34.0877 20.4832 1.52986 -2.36109 -0.337181 -6380 4 53.937 35.2424 19.4598 0.882668 -0.831705 10.9264 -6381 6 42.0694 14.2202 28.4717 21.1483 -3.98018 21.7174 -6382 4 41.9885 13.9669 29.4143 -10.3093 2.59547 -11.4583 -6383 4 43.02 14.3987 28.405 -3.82604 1.35242 -7.96462 -6384 6 34.8498 7.69636 26.7062 10.2576 -3.81921 3.94078 -6385 4 35.6291 7.30563 27.124 0.895866 5.46509 7.50645 -6386 4 34.5698 7.0105 26.0965 -7.64543 -1.95318 -6.87837 -6387 6 49.6738 30.7035 23.8555 -19.3272 -4.41511 -13.3992 -6388 4 50.4901 31.166 23.8286 28.3544 13.2291 -0.764283 -6389 4 49.8241 29.9642 24.4268 4.30872 -17.0733 16.2757 -6390 6 50.9008 7.796 14.1645 9.55664 -5.64416 8.78132 -6391 4 50.8079 7.01141 13.6383 2.57079 -23.1487 -4.84087 -6392 4 50.5017 8.45024 13.6177 -13.1237 27.0593 -11.2067 -6393 6 4.26801 39.4668 27.8349 5.05862 -9.29033 0.915363 -6394 4 3.69733 40.2352 27.9464 -2.13812 3.43039 0.251988 -6395 4 3.85787 38.9439 27.1453 -8.48589 -4.99062 -8.23097 -6396 6 8.74801 32.8245 8.20645 -16.3778 -23.5545 -4.64115 -6397 4 8.1587 32.1369 7.77132 15.1044 25.0089 5.08958 -6398 4 8.83862 33.6223 7.65804 -4.44885 -3.27239 -3.39484 -6399 6 52.9644 25.4956 9.38778 -23.0628 41.5097 8.07386 -6400 4 51.9653 25.4466 9.50894 36.2156 4.27363 -7.84863 -6401 4 53.1697 26.4737 9.50477 -8.20239 -39.1491 -3.41364 -6402 6 29.5595 36.7246 19.4744 18.9803 -2.04176 16.4704 -6403 4 29.6949 37.303 18.726 -4.20274 3.37351 -9.90607 -6404 4 30.4598 36.6303 19.854 -15.3589 -5.02994 0.251134 -6405 6 52.32 36.0811 25.1124 8.57954 -21.5781 -32.5589 -6406 4 53.081 35.9362 25.6725 3.50304 3.9365 6.54391 -6407 4 51.6308 36.4579 25.6293 -16.5409 10.2166 18.3955 -6408 6 21.1806 15.7021 31.1799 -1.73968 4.64344 -14.8668 -6409 4 20.7524 16.2958 30.5301 6.89899 -9.15256 14.6363 -6410 4 20.4997 15.2544 31.7027 -1.32541 3.0922 -5.22806 -6411 6 10.6615 22.4234 39.4446 2.77058 -10.3375 -21.7461 -6412 4 10.8237 22.5242 38.4595 -6.54577 -4.89624 27.0726 -6413 4 10.2823 21.5329 39.6036 8.10661 10.4602 -7.72978 -6414 6 25.1119 11.6683 22.7275 17.9584 10.1803 -43.002 -6415 4 25.2932 11.5881 23.6503 -10.3644 -4.73542 30.1579 -6416 4 24.2275 11.4525 22.4127 -3.04384 -6.16919 15.0614 -6417 6 31.7847 10.4664 2.90738 14.6232 4.92747 -25.5509 -6418 4 32.6367 10.8084 3.16838 3.35352 3.27745 17.8769 -6419 4 31.9203 10.4929 1.94425 -15.217 -5.45404 8.94289 -6420 6 52.4827 36.4345 22.1596 -7.80713 -36.8893 3.58418 -6421 4 53.0619 36.0081 21.4904 -7.85296 7.00584 7.09748 -6422 4 52.1113 35.6558 22.6625 11.8438 27.843 -13.8236 -6423 6 46.2218 40.0356 27.0002 3.00948 19.3103 18.0239 -6424 4 46.4695 39.2891 26.4839 7.60887 -23.2108 -12.3358 -6425 4 45.8298 40.6551 26.3816 -4.98516 2.75312 2.41297 -6426 6 24.0859 36.731 39.1057 28.0861 3.14637 -13.7231 -6427 4 23.7868 35.8298 38.9338 -5.18553 -0.74556 5.28182 -6428 4 23.4629 37.185 39.6652 -17.6872 -1.49015 10.8999 -6429 6 22.3474 7.42423 31.8108 -22.1464 -34.764 6.81692 -6430 4 22.3426 8.34479 32.0749 -0.491553 12.3501 5.32307 -6431 4 21.6443 6.94951 32.3421 24.5486 22.6275 -17.4273 -6432 6 14.3601 18.3609 4.10227 -5.91068 -17.6869 34.0105 -6433 4 14.0198 17.4467 4.00899 4.58845 16.3972 -3.13031 -6434 4 14.1964 18.4938 5.07185 10.0688 2.42213 -23.7444 -6435 6 27.3176 38.4584 0.118061 26.6324 1.72941 22.4386 -6436 4 26.8721 39.2229 0.514978 -6.24738 0.955789 -1.68833 -6437 4 28.1825 38.4197 0.615747 -27.5588 -2.17115 -12.0629 -6438 6 18.6641 0.153005 12.2455 -30.1585 11.9093 7.70812 -6439 4 17.6838 0.288413 12.4195 29.795 -10.6896 -3.23208 -6440 4 18.9224 41.3021 12.7767 -6.14336 -8.14908 8.56265 -6441 6 49.4289 24.9791 25.34 -2.93287 6.40986 -7.21031 -6442 4 48.5336 24.6845 25.5066 -4.79022 -10.2209 3.00881 -6443 4 49.2657 25.7332 24.7569 10.0796 0.538989 -0.302405 -6444 6 52.0657 20.2866 15.752 -30.988 -5.77477 12.2451 -6445 4 52.9883 20.4648 15.7877 30.7647 6.19501 2.10932 -6446 4 51.7487 20.318 16.6754 2.59628 0.707672 -8.61894 -6447 6 49.6694 15.6466 38.5033 -2.36871 5.8496 0.21755 -6448 4 49.1634 15.9354 37.7317 2.81773 -6.75889 -8.88584 -6449 4 49.3364 16.2327 39.1899 -1.1635 1.82265 11.9188 -6450 6 15.9209 23.7098 13.4125 14.0576 3.0382 28.6395 -6451 4 16.4576 23.7581 14.2247 -6.14337 -14.5589 -15.9509 -6452 4 15.4928 24.5639 13.4473 -12.8057 7.70559 -12.0572 -6453 6 14.3535 29.1644 14.3158 -5.44214 8.41065 -10.6214 -6454 4 14.1107 29.5404 13.4323 4.3831 -8.60004 22.5031 -6455 4 14.1668 29.874 14.9595 1.02369 -3.68708 -8.8215 -6456 6 30.4209 19.8501 16.8941 13.513 -29.8099 -4.40702 -6457 4 30.8419 19.6061 17.7309 -1.16118 4.00396 0.0836579 -6458 4 29.8867 20.6126 17.0073 -13.0379 22.0094 6.56408 -6459 6 21.3171 21.0315 23.1347 13.77 4.04154 19.3244 -6460 4 22.2214 21.2364 23.4619 -15.8088 -1.32345 -6.31481 -6461 4 20.7299 21.1568 23.8987 5.07857 1.54253 -3.54042 -6462 6 32.3393 0.431439 25.2563 20.1104 -9.0179 2.05206 -6463 4 32.3376 0.357033 24.2893 -5.83171 4.85221 4.50445 -6464 4 31.4939 0.740536 25.5658 -20.5297 5.12544 -3.04931 -6465 6 26.1412 32.4208 27.5133 11.9844 8.82666 12.5058 -6466 4 25.6297 33.2181 27.3271 -3.7928 0.326337 -6.17907 -6467 4 25.9506 31.7475 26.8638 -6.12498 -3.36782 -14.5181 -6468 6 31.6886 23.0183 41.4596 0.904697 7.64904 11.3452 -6469 4 32.5758 22.6752 41.6838 -11.075 0.532718 -2.08438 -6470 4 31.0649 22.7115 0.227606 5.71652 1.16966 -4.3825 -6471 6 54.3662 17.838 10.7289 1.16641 13.6113 28.4031 -6472 4 53.5784 18.2682 10.4091 -15.835 11.3767 1.3744 -6473 4 54.5574 17.2244 10.05 12.0924 -25.2322 -22.7117 -6474 6 15.4007 28.5656 8.62044 -26.1749 5.76845 -41.3303 -6475 4 14.7273 28.9702 8.01425 13.7656 -2.21873 23.1298 -6476 4 15.8479 27.9621 8.001 5.22436 1.48231 12.0756 -6477 6 21.9302 22.318 27.6758 1.68517 -22.7815 -10.3197 -6478 4 22.2029 23.2377 27.6948 5.32233 7.77922 8.4028 -6479 4 21.9507 21.9579 28.5708 1.77406 4.33165 6.10734 -6480 6 2.9439 17.0434 8.14058 1.94164 -24.3442 -12.3304 -6481 4 3.71771 17.0381 7.53295 -10.9103 8.58946 10.7103 -6482 4 2.9095 17.8301 8.67828 12.1388 15.179 1.9509 -6483 6 27.5776 18.2769 3.9771 26.0492 -34.2565 5.18616 -6484 4 26.8914 18.9079 3.85686 -19.1066 25.6869 -8.0303 -6485 4 28.3968 18.6065 3.57961 -12.2542 3.89161 2.52414 -6486 6 24.7648 24.5394 8.45172 0.675902 5.99664 -6.73781 -6487 4 25.0691 23.6382 8.29185 0.995795 -2.08458 0.0885467 -6488 4 24.6379 24.6158 9.40394 1.7631 1.80546 -0.516948 -6489 6 41.9985 30.4652 13.7873 -12.418 22.2399 8.0521 -6490 4 42.948 30.5766 13.6065 -4.54142 -18.1038 -0.632901 -6491 4 41.6543 29.5567 13.7855 17.2179 -0.450275 -1.52495 -6492 6 15.7003 34.688 41.5836 22.5583 -4.71252 2.77114 -6493 4 16.4414 35.3131 41.7067 -7.89455 1.74939 1.29748 -6494 4 14.9091 35.1782 41.7999 -10.5684 8.94915 5.66738 -6495 6 11.14 19.7709 40.5827 8.16812 -24.8495 -13.7269 -6496 4 12.099 19.6958 40.4335 -6.97557 5.6239 6.72769 -6497 4 10.8269 18.8658 40.3418 -4.09458 16.1616 8.77151 -6498 6 47.4994 34.5266 14.3059 -7.29954 -13.2064 -47.3862 -6499 4 46.9486 35.2618 14.0194 -1.26876 14.2822 14.9014 -6500 4 47.5134 34.0178 13.447 14.161 -1.19014 30.6955 -6501 6 12.4113 26.9599 28.4986 7.53387 -39.615 -11.3807 -6502 4 13.2389 26.8759 29.0383 -9.69033 -7.26437 -10.917 -6503 4 12.3547 26.143 27.8911 8.77392 33.3418 27.7102 -6504 6 27.6324 16.2078 39.8226 -15.7166 38.3334 10.2244 -6505 4 27.1738 15.4871 40.2515 -0.529449 -16.0233 0.418904 -6506 4 28.2783 15.8881 39.2072 13.4358 -18.0852 -11.4488 -6507 6 33.41 31.2223 27.2648 1.06056 32.1352 -34.8736 -6508 4 34.1408 31.8147 27.4795 4.37007 -7.45055 8.12396 -6509 4 32.9956 31.7298 26.5244 2.74339 -19.701 12.9858 -6510 6 39.1079 39.5697 31.9277 -2.55925 2.09297 0.92959 -6511 4 38.7672 39.6549 31.0188 2.43701 -1.71218 7.87361 -6512 4 38.6143 40.212 32.4659 5.60044 -5.69156 -1.85126 -6513 6 22.8777 16.5449 19.9566 -5.65986 -8.80894 -1.36967 -6514 4 23.3352 15.8067 20.4264 -14.7096 4.17994 -10.0586 -6515 4 22.0919 16.2116 19.4632 15.4216 -6.99735 9.66589 -6516 6 23.9693 21.8661 10.5894 -36.2244 3.36606 3.40233 -6517 4 22.9782 21.9097 10.6297 20.8239 3.29656 -5.85881 -6518 4 24.1356 21.2379 11.286 10.3432 -8.66819 12.8402 -6519 6 40.1777 25.441 2.79106 -10.2872 18.2283 6.37262 -6520 4 40.1705 25.0132 3.63888 8.49445 -17.5146 10.0011 -6521 4 39.7592 26.2809 3.01477 -1.02299 2.45309 -8.63041 -6522 6 15.0237 19.7749 9.41859 -29.0071 17.4399 5.80075 -6523 4 14.7228 20.7104 9.1599 7.38 -34.1593 9.70733 -6524 4 14.2459 19.2857 9.84339 25.5779 21.3804 -17.4983 -6525 6 7.16152 24.8628 0.123297 -7.02966 -3.56682 11.7049 -6526 4 7.96668 24.8036 41.5398 15.214 -7.46464 -23.6733 -6527 4 7.46323 25.2953 0.914133 -6.27594 4.44234 13.0485 -6528 6 43.3927 10.9201 31.3407 25.4071 10.106 7.84859 -6529 4 43.8098 10.8609 30.45 -7.40798 -0.791197 19.4909 -6530 4 44.1598 10.9733 31.9767 -21.009 -0.343387 -21.8186 -6531 6 13.8353 19.068 27.8558 -6.19586 12.3763 0.85665 -6532 4 12.975 18.7858 28.1864 -1.64107 2.23065 2.52451 -6533 4 13.8413 20.053 27.8412 2.88957 -13.8419 -2.19198 -6534 6 3.4728 19.5924 9.6022 -44.5705 9.69836 1.75794 -6535 4 2.70361 20.0095 10.0844 20.5969 -13.9146 -9.89239 -6536 4 4.25765 19.8234 10.0844 13.5534 0.0599395 5.99295 -6537 6 51.0213 19.4268 7.70955 2.43945 12.0622 -23.2725 -6538 4 50.6325 20.2627 7.28999 21.6228 -31.5555 10.1722 -6539 4 51.8004 19.115 7.16203 -27.7652 18.9123 7.69536 -6540 6 42.2139 2.59999 10.4154 11.3377 -7.01405 -0.847173 -6541 4 43.144 2.57533 10.7556 -19.516 1.89174 -10.2127 -6542 4 42.1979 2.39197 9.45142 9.27815 6.14572 20.7298 -6543 6 30.7794 6.42968 35.1975 -13.4378 -7.3385 -2.08895 -6544 4 29.8146 6.43175 35.3648 9.73054 -4.02703 -1.93701 -6545 4 31.052 5.50707 35.0427 -6.67101 6.52405 0.860042 -6546 6 52.8733 36.9495 18.5906 -4.95733 10.1612 -6.16245 -6547 4 51.9909 36.5548 18.5738 -2.549 -5.51132 1.40056 -6548 4 52.7192 37.8514 18.247 7.64894 -10.0112 4.74408 -6549 6 44.2058 6.2999 1.04709 5.21291 8.10008 11.2107 -6550 4 44.5368 6.97198 1.69742 -2.24215 -10.2401 -12.34 -6551 4 44.9393 6.09517 0.464894 1.54959 1.89788 1.1267 -6552 6 42.1369 38.61 31.1886 17.67 -9.24899 26.4806 -6553 4 41.7623 38.8803 30.3687 -14.3725 6.55505 -24.001 -6554 4 41.498 38.8614 31.8609 -3.32676 4.75778 -0.202389 -6555 6 43.7164 12.7972 9.05712 5.81528 3.72875 -30.711 -6556 4 43.3247 13.6946 8.89573 9.87346 -21.9812 3.16194 -6557 4 44.14 12.4709 8.19462 -12.6006 16.8915 32.7492 -6558 6 13.3844 0.443398 6.51083 -17.4423 24 5.83044 -6559 4 13.1471 1.18968 7.12521 11.9969 -17.0568 -16.1514 -6560 4 13.404 0.824606 5.60344 -0.330864 -2.32474 10.3957 -6561 6 16.1322 13.2809 10.2756 -7.67495 0.483234 -7.74316 -6562 4 16.9315 12.7781 10.4995 -2.28882 -8.98658 -2.43525 -6563 4 15.4389 12.669 9.92885 16.2568 3.72445 6.60733 -6564 6 1.59909 8.47465 4.69565 -12.106 -24.0688 17.9122 -6565 4 1.97809 9.06493 4.05503 13.7499 12.9224 -12.6029 -6566 4 2.17818 8.51684 5.47441 1.43398 4.73372 -5.14276 -6567 6 37.2847 1.71984 10.5234 11.0189 -27.5723 -13.4042 -6568 4 37.2468 2.67416 10.4778 -4.00861 9.27523 10.0347 -6569 4 36.8996 1.35439 11.335 -2.27729 16.2243 3.90618 -6570 6 53.8329 9.87891 17.6846 -38.3798 -30.924 7.14602 -6571 4 54.5301 10.0186 17.0634 18.0368 1.02749 -18.7159 -6572 4 53.3473 9.06138 17.3773 12.8854 20.2391 7.24153 -6573 6 45.4804 30.6107 15.8042 -8.04753 0.598448 7.23065 -6574 4 44.8245 31.2304 16.205 12.7241 -16.0174 -7.51778 -6575 4 45.2045 29.6903 15.9459 -0.384376 11.4708 0.631615 -6576 6 39.9212 16.643 33.8508 -27.7636 -7.17353 -19.4615 -6577 4 39.1766 17.1755 33.458 21.1378 -12.4278 10.7513 -6578 4 39.8244 15.7487 33.4296 5.23768 21.8708 14.061 -6579 6 32.8655 24.7639 27.9361 20.284 59.6053 -7.49862 -6580 4 33.6165 25.1458 28.4374 -8.60268 -19.6727 -0.650124 -6581 4 32.6313 25.5876 27.4183 -1.69816 -34.155 10.7383 -6582 6 7.87466 31.6143 24.1101 1.9117 20.6925 26.3443 -6583 4 7.66972 30.8573 24.7192 5.27436 26.873 -8.7819 -6584 4 7.9908 32.4716 24.6533 -12.57 -44.6195 -20.0842 -6585 6 43.5378 41.3358 15.8218 9.28004 -2.58796 -1.50951 -6586 4 43.1443 0.2957 15.6997 -2.19094 2.48586 -2.7957 -6587 4 44.4004 41.3722 15.3768 -7.99823 -0.449815 2.36698 -6588 6 20.0371 29.5453 33.205 3.08504 -20.5033 -11.6211 -6589 4 20.9096 29.2965 33.5637 -2.90058 10.2459 9.35691 -6590 4 19.6251 30.2513 33.706 8.84517 7.80605 8.87396 -6591 6 43.4117 21.4438 18.6347 -11.1342 -15.0059 14.8538 -6592 4 43.0276 21.2687 19.5098 8.56326 4.46648 -0.801958 -6593 4 42.8532 20.9111 18.0542 1.01153 2.95656 -9.2223 -6594 6 3.44653 19.1197 18.4217 23.6769 1.99723 9.81042 -6595 4 3.20802 20.045 18.3207 -2.32682 2.96104 -2.33529 -6596 4 2.63398 18.6303 18.3598 -12.7596 -8.76931 -2.32568 -6597 6 41.6678 38.1102 16.3244 12.531 -42.2252 -39.0953 -6598 4 41.9368 37.3879 15.641 -15.3799 38.9729 30.6603 -6599 4 42.3331 38.0554 17.0146 -0.0757724 1.18921 2.99625 -6600 6 7.55561 36.3978 10.4983 -3.44092 15.1931 -1.45671 -6601 4 6.72339 36.2337 10.0108 12.3142 -8.52859 4.51616 -6602 4 7.946 35.5335 10.7116 -10.6452 2.04557 -4.50299 -6603 6 36.2515 19.1074 34.8142 -43.7142 -17.0801 -27.3746 -6604 4 35.3817 19.3303 34.3863 23.1726 -6.06315 12.306 -6605 4 36.4633 19.8781 35.3097 10.3 22.3537 14.1292 -6606 6 53.5678 24.9372 12.6442 30.4342 18.5181 -32.2976 -6607 4 53.8348 25.8921 12.6266 -11.9077 -21.6197 10.5864 -6608 4 54.0165 24.5977 11.8224 -16.4724 -4.37861 26.9125 -6609 6 31.6766 10.443 21.0806 4.21881 -9.06253 -2.47208 -6610 4 31.4001 9.76622 21.7243 -7.70504 9.2495 -8.08332 -6611 4 30.9288 10.6617 20.4921 1.78432 -8.02731 8.28605 -6612 6 18.1094 28.7798 17.1891 14.7524 22.0605 -19.6834 -6613 4 19.0758 28.769 16.9872 -20.2742 -2.10771 9.28657 -6614 4 17.7731 29.5847 16.7123 5.43167 -23.0331 15.3038 -6615 6 21.675 18.2354 36.8765 16.12 -15.5286 8.52342 -6616 4 22.5529 17.9072 36.565 -22.4082 10.693 4.11156 -6617 4 21.5572 17.762 37.7329 -6.04816 8.67317 -10.9669 -6618 6 25.0658 19.0188 34.2159 -51.8076 2.97265 19.7815 -6619 4 24.747 18.4039 34.9114 5.38902 10.2451 -10.362 -6620 4 25.8774 18.6629 33.96 52.7001 -22.9877 -15.275 -6621 6 15.5692 13.0234 5.56242 -6.58245 2.44228 -13.4315 -6622 4 15.9945 13.4237 6.33643 -0.981395 -11.5063 2.18089 -6623 4 15.4281 12.0558 5.58603 5.20341 13.6823 8.40676 -6624 6 54.4716 41.6235 14.8012 14.2089 2.8312 2.80672 -6625 4 54.7869 41.5367 15.7234 -10.706 -4.16636 -8.71187 -6626 4 53.6678 41.1066 14.6963 -6.31993 -3.99892 7.53898 -6627 6 1.6781 26.4654 31.3743 5.67012 -21.4195 51.4057 -6628 4 2.55869 26.331 31.7713 -6.41431 -1.4007 -7.54986 -6629 4 1.81482 26.7235 30.4972 11.6805 15.9936 -52.9786 -6630 6 32.3382 37.285 29.6856 -26.7217 17.5069 7.43983 -6631 4 31.5807 37.8924 29.918 20.5429 -15.6126 -5.39856 -6632 4 33.128 37.6701 30.0913 2.74033 -1.11204 0.131524 -6633 6 52.7155 21.0369 22.8986 -26.6856 13.1044 -7.83906 -6634 4 51.927 21.5218 22.5308 17.9584 -10.8856 16.9396 -6635 4 53.1096 20.6236 22.131 10.0871 -9.76004 -3.40095 -6636 6 32.7546 28.5936 40.5151 -16.005 5.57574 20.6704 -6637 4 31.9696 29.0914 40.2712 1.08408 5.35728 -15.103 -6638 4 32.4826 28.2925 41.3957 13.2257 -7.23298 -6.66392 -6639 6 23.6064 32.0719 16.3529 6.2601 0.887785 0.577407 -6640 4 24.375 31.9361 16.9584 -22.6405 4.1158 -3.2487 -6641 4 22.7879 32.3052 16.8361 12.3926 -5.56708 -0.502672 -6642 6 37.5201 9.16809 29.9792 -2.73778 -7.47015 7.66604 -6643 4 36.7801 8.78215 30.4957 3.311 11.363 -11.2805 -6644 4 37.2059 9.98527 29.541 -5.1069 -9.85197 8.55889 -6645 6 2.27705 24.391 14.5477 -18.8311 -23.8216 -15.5117 -6646 4 1.75426 24.0938 15.3142 10.0576 11.8704 2.19803 -6647 4 1.95568 23.7778 13.8474 11.5886 17.7779 11.9828 -6648 6 27.3753 28.7961 24.7726 7.21008 -25.2057 -20.8265 -6649 4 27.1644 28.4274 25.6317 -2.92196 -0.0765173 10.3399 -6650 4 27.4291 28.0161 24.1505 1.02404 24.316 14.9 -6651 6 16.7879 2.56531 14.3086 11.9129 14.2285 -1.69346 -6652 4 17.7185 2.38196 14.3175 13.0278 5.32386 8.84309 -6653 4 16.4775 1.81817 13.8231 -22.7045 -15.6449 -12.1127 -6654 6 21.8022 39.8027 36.8001 40.4582 11.674 1.33338 -6655 4 22.755 39.5599 36.9347 -17 12.4394 -0.288792 -6656 4 21.461 38.9709 36.5396 -21.7153 -28.8447 -11.0269 -6657 6 14.0716 6.47232 41.542 21.0202 -14.2424 -6.97231 -6658 4 14.9696 6.10406 41.5939 -1.81915 -4.72532 -7.76656 -6659 4 14.0403 6.99701 0.421866 -13.8031 9.98176 13.4178 -6660 6 14.5555 16.5106 9.31543 20.3876 4.44524 4.12907 -6661 4 15.4025 16.5964 9.78828 0.864554 -6.42184 -12.9633 -6662 4 13.9847 17.046 9.86181 -12.8914 3.93145 3.80898 -6663 6 8.66171 23.4817 30.5575 -0.244333 -0.896371 32.8135 -6664 4 9.54353 23.6001 30.2398 18.7576 4.73722 -27.2602 -6665 4 8.85707 23.3999 31.5064 -16.6456 -3.41855 -0.290363 -6666 6 37.6497 2.07069 20.0046 29.2824 -26.1096 14.9164 -6667 4 37.0584 2.2163 19.2662 -13.6051 13.4744 -1.64318 -6668 4 37.4656 2.68422 20.7276 -9.488 6.31449 -9.7769 -6669 6 42.7264 7.54802 8.0174 22.2735 -23.3375 63.966 -6670 4 43.1898 7.96838 7.30926 14.9789 10.8108 -11.9713 -6671 4 43.3711 7.43923 8.8454 -34.4126 10.1207 -51.4479 -6672 6 38.5672 29.6578 6.85692 25.3422 5.29964 1.58487 -6673 4 38.5311 29.2984 7.75245 -9.71234 0.328663 -2.10015 -6674 4 37.7248 29.5682 6.41889 -15.2832 -4.18317 0.54199 -6675 6 42.5348 15.7114 39.7967 1.15785 13.3588 -25.5786 -6676 4 42.7129 16.6429 39.5831 1.88136 -1.51067 11.9166 -6677 4 42.2359 15.3735 38.9271 3.70013 -4.77916 17.2749 -6678 6 19.8546 7.43685 22.0566 -22.5975 2.81071 25.7956 -6679 4 19.2803 8.13273 21.6746 8.521 -7.13733 1.21439 -6680 4 19.4015 7.21173 22.9242 12.7412 8.86068 -31.9054 -6681 6 27.421 3.23371 12.5304 27.0524 21.0752 -24.489 -6682 4 28.3367 3.35644 12.1327 -27.9555 -7.8832 14.1518 -6683 4 27.3543 2.31638 12.8154 4.42645 -1.52034 -0.990676 -6684 6 34.4011 6.50186 34.3664 -16.3424 -2.90191 9.94761 -6685 4 33.6712 7.15225 34.4215 6.78416 -7.62851 1.00734 -6686 4 34.1394 5.7575 34.9538 2.66911 12.7001 -5.69623 -6687 6 9.88701 27.9536 39.7574 38.1218 -1.21446 9.36845 -6688 4 10.8313 27.9815 40.1009 -35.4969 -5.93471 -11.3457 -6689 4 9.7403 28.8357 39.397 -3.9481 4.17466 -3.11552 -6690 6 50.5681 22.1235 6.40489 -3.33101 1.51672 6.50125 -6691 4 51.5163 22.3536 6.46403 -14.0562 3.33212 10.0382 -6692 4 50.0608 22.5915 7.10741 15.6039 -2.37345 -9.267 -6693 6 47.1098 11.477 30.0359 32.4056 2.61276 18.961 -6694 4 47.3696 10.9259 30.8115 -10.3246 7.95021 -16.9085 -6695 4 46.3045 11.1726 29.6407 -20.48 -14.5539 -1.24473 -6696 6 25.9367 28.4654 9.80931 -8.38409 -27.2904 31.5361 -6697 4 26.8395 28.2564 10.1264 -14.1867 1.81997 -4.27567 -6698 4 25.3175 27.9176 10.3882 19.4096 21.4407 -17.1039 -6699 6 35.4417 36.6052 19.4431 3.65383 9.51374 12.5698 -6700 4 35.4442 36.5892 20.4356 4.35023 4.13201 -20.4161 -6701 4 36.0823 37.2978 19.1702 -7.18083 -5.57131 7.61291 -6702 6 39.0947 17.861 12.3005 -1.37104 18.7141 6.38745 -6703 4 39.0516 18.8013 12.5757 6.4741 -5.57949 -8.41576 -6704 4 38.3925 17.481 12.8252 -9.64523 -10.3587 5.73293 -6705 6 2.67895 27.1328 2.39169 -0.469231 -1.96621 -7.87892 -6706 4 2.01695 27.5866 1.84113 6.06579 -3.44887 4.00529 -6707 4 2.54603 27.3828 3.31988 1.36543 -1.57126 -4.01383 -6708 6 12.3125 32.2183 21.5204 7.73608 31.3279 -34.5621 -6709 4 12.8754 32.1648 22.302 -15.5368 -9.13091 6.69049 -6710 4 11.4514 31.7997 21.5885 -0.151568 -8.94455 23.3893 -6711 6 32.8824 32.3641 8.46179 -18.8611 4.30442 3.1153 -6712 4 33.4241 32.9657 8.96292 17.2175 7.79223 5.74753 -6713 4 32.0088 32.7748 8.50666 0.635289 -6.40729 -7.5616 -6714 6 12.649 6.44414 31.9754 -2.83404 4.50046 10.0363 -6715 4 13.204 6.32185 31.2101 8.19857 -2.9014 -11.0209 -6716 4 11.7563 6.235 31.704 -2.09981 -3.08597 -3.85403 -6717 6 41.3663 27.7408 14.044 -7.1512 -14.0341 -18.9391 -6718 4 41.8178 27.3798 13.2339 -12.2472 13.3456 19.5442 -6719 4 40.4043 27.5413 13.9741 19.5004 0.843126 1.31278 -6720 6 6.61204 16.505 25.4358 4.38086 10.1107 -4.22872 -6721 4 7.40634 15.95 25.3995 -3.52048 -0.326181 -5.74655 -6722 4 5.93615 16.0015 24.9584 5.4209 -2.01242 3.85811 -6723 6 21.7595 39.2992 13.3504 -47.5104 6.20728 42.9111 -6724 4 22.3466 39.2605 12.6295 26.4998 6.28224 -34.1528 -6725 4 21.7095 40.2078 13.7281 10.6984 -16.5323 -14.9329 -6726 6 34.8487 6.01484 6.95222 -29.6963 0.326386 -14.1862 -6727 4 33.862 5.88861 6.88689 25.1099 2.0969 11.0318 -6728 4 35.0754 6.24807 6.0365 6.49139 -1.48305 5.74594 -6729 6 33.0274 30.4243 33.1708 -20.2868 -13.6057 -33.0226 -6730 4 32.107 30.5622 32.8069 24.6222 -1.48625 15.7647 -6731 4 33.1252 31.0225 33.8918 -2.19017 18.1524 16.6028 -6732 6 15.459 32.4153 12.1907 25.026 -14.7999 12.6103 -6733 4 16.3707 32.0454 12.2858 -22.5133 7.43237 -2.39957 -6734 4 15.4871 32.8857 11.3664 4.63911 10.1509 -16.175 -6735 6 12.6896 26.6018 21.3639 -15.0944 -25.6853 -2.70918 -6736 4 11.948 26.0906 21.6799 0.937138 -29.673 -19.3981 -6737 4 12.542 27.2759 21.9777 19.0907 58.813 21.5342 -6738 6 47.0229 36.3064 29.9951 -7.32095 -4.41829 24.4392 -6739 4 47.4263 37.0889 30.4354 -10.9743 -13.05 -1.23566 -6740 4 46.4286 35.8162 30.6445 23.161 23.2616 -16.2608 -6741 6 0.29284 12.714 23.4069 -35.5625 7.7859 6.41586 -6742 4 0.591011 11.8915 23 -3.04289 0.952694 -0.179009 -6743 4 54.2726 12.6526 23.4069 36.7156 0.482893 -0.227565 -6744 6 54.1717 18.9252 21.5683 -50.0663 20.0699 0.290361 -6745 4 -0.00468748 18.6783 21.9698 30.2345 -16.5238 -1.58257 -6746 4 54.0846 18.73 20.626 15.626 -5.42297 0.74208 -6747 6 25.7258 24.2992 23.7444 19.803 -45.4072 -0.235584 -6748 4 25.1532 23.5493 23.4006 14.0979 28.9064 13.4272 -6749 4 26.557 23.8171 24.0636 -29.432 23.3848 -10.2309 -6750 6 11.8983 29.0288 26.8736 6.09277 -0.515715 3.71925 -6751 4 12.595 29.6797 27.0784 -3.35093 -5.68029 1.25498 -6752 4 11.9864 28.3255 27.5444 1.01315 10.8055 -7.75858 -6753 6 47.9911 35.8567 10.6981 8.08413 -4.02984 -21.6227 -6754 4 48.7745 35.7734 10.1229 -13.6418 -1.85084 -2.1863 -6755 4 48.3792 36.2903 11.4463 -1.30569 7.34959 21.4512 -6756 6 47.672 29.8438 36.9511 38.562 -32.0587 -16.7646 -6757 4 48.1514 29.311 36.2244 -26.8687 25.3781 26.6073 -6758 4 46.9232 30.3209 36.5927 -0.690739 -0.634879 -8.58348 -6759 6 7.33835 12.3416 10.615 -8.89583 -3.33234 -10.1121 -6760 4 7.22469 12.7824 9.73793 -1.24183 -8.23722 19.221 -6761 4 6.50851 12.5236 11.1156 17.4449 -0.896679 -14.5349 -6762 6 52.929 15.961 4.90278 -10.2898 -1.28264 -8.50781 -6763 4 53.0348 16.1145 3.95774 -1.18717 -0.815743 4.35872 -6764 4 53.806 16.0238 5.26597 15.814 -0.370642 9.21047 -6765 6 10.6777 16.9586 34.6035 -55.1347 -38.7426 5.67968 -6766 4 10.8984 16.7766 35.5088 23.7364 14.024 15.8473 -6767 4 9.8802 16.3472 34.5582 30.0556 27.9196 -18.3163 -6768 6 25.1377 31.056 36.0048 1.42921 -10.848 -28.6765 -6769 4 25.7744 31.7772 36.0714 -0.417948 1.95283 3.18329 -6770 4 25.3475 30.6244 35.1463 -8.66047 8.51414 18.9355 -6771 6 34.0941 21.8921 41.4705 -2.59948 8.49748 21.8065 -6772 4 33.8376 21.0023 41.2487 -0.891159 -17.6747 -3.00217 -6773 4 34.5263 22.2081 40.6953 10.3371 11.5397 -24.1167 -6774 6 15.7674 30.0637 1.25444 19.4532 4.17941 -23.0135 -6775 4 15.204 30.4318 1.91689 -16.4157 4.77211 21.8875 -6776 4 16.1981 30.8773 0.915598 -5.77798 -19.2538 1.08217 -6777 6 29.5177 27.8662 16.6069 -21.9867 -20.8772 26.8051 -6778 4 29.4575 26.8938 16.8925 2.72258 42.9501 -5.19299 -6779 4 28.8337 28.3532 17.1557 16.905 -14.8206 -13.8895 -6780 6 39.6418 9.77683 0.55649 6.97543 15.8838 23.3716 -6781 4 40.1108 10.6055 0.868863 -11.4024 -23.0197 -7.66085 -6782 4 39.4946 9.23542 1.36828 3.21978 8.9832 -14.2415 -6783 6 1.52158 31.8692 16.4183 -13.8984 7.04184 27.8471 -6784 4 2.05742 32.2974 15.7673 16.5414 8.9668 -16.2997 -6785 4 1.54493 30.9444 16.2035 3.31157 -20.7597 -8.56027 -6786 6 8.73651 39.8559 25.0424 -4.76165 -15.5453 0.0774869 -6787 4 8.05377 39.648 25.6948 0.177415 -5.7342 -2.33302 -6788 4 8.86744 40.7877 25.1714 9.39418 20.2019 -3.50565 -6789 6 42.3206 10.2864 9.76098 2.95973 19.1246 -1.63703 -6790 4 42.201 10.133 10.7061 4.21692 -0.996774 -0.328573 -6791 4 42.7677 11.1578 9.6855 -5.09192 -13.1904 -0.0451331 -6792 6 13.2407 7.61713 1.96996 -7.39862 -1.41628 8.88927 -6793 4 13.9913 7.91748 2.51852 -7.45732 -2.50241 0.703823 -6794 4 12.5579 7.21318 2.54911 15.3337 9.06064 -6.21655 -6795 6 18.7418 40.0591 14.2229 14.6643 6.60726 6.61579 -6796 4 19.3344 39.8885 14.9901 -13.3575 3.17545 -12.3588 -6797 4 17.9636 39.4956 14.2872 3.6042 -5.87931 7.54738 -6798 6 20.1073 14.0529 38.5598 27.8117 -61.2518 1.76132 -6799 4 20.1641 13.6472 37.6602 -4.05869 13.902 17.7453 -6800 4 19.784 14.907 38.4293 -21.3136 56.4597 -12.4562 -6801 6 22.6529 28.8869 34.0687 6.58134 -12.6264 20.4136 -6802 4 23.051 28.2341 33.486 -0.980474 2.102 -8.59088 -6803 4 22.967 28.5961 34.9503 -6.50134 7.38476 -6.63172 -6804 6 22.6736 4.71248 5.24178 -0.00794307 -2.96021 -16.86 -6805 4 22.1728 3.90748 5.48978 2.26378 16.1145 9.27739 -6806 4 22.7088 5.35566 5.95806 -4.05577 -5.29394 11.9552 -6807 6 23.6374 34.0001 38.3917 50.061 26.1352 -20.3518 -6808 4 22.8137 33.6238 38.6177 -41.7704 -11.5062 -0.965889 -6809 4 23.6153 34.3835 37.4812 -9.56218 -11.3792 16.4738 -6810 6 48.3816 21.3644 17.2759 -0.964958 21.4078 15.1884 -6811 4 48.1603 22.346 17.2347 5.31328 -30.3781 -7.15015 -6812 4 48.2799 20.9337 16.4123 -2.86285 15.3202 1.32987 -6813 6 11.5786 11.0066 8.63803 -22.8025 30.9503 41.2381 -6814 4 11.6342 10.2487 9.24135 6.24209 -4.12245 -6.65597 -6815 4 11.0653 11.6976 9.17674 20.0011 -23.9124 -25.5895 -6816 6 40.098 28.1667 33.502 25.4322 5.13826 0.328547 -6817 4 41.0532 28.3457 33.4282 -8.43417 -7.39989 8.78785 -6818 4 39.8078 28.5143 32.6608 -12.8477 1.2165 -2.93222 -6819 6 47.3852 25.6796 5.28879 12.5804 32.9376 -10.0311 -6820 4 46.4546 25.5561 5.13624 -16.8804 -10.2001 -0.268496 -6821 4 47.5232 26.6241 5.03253 2.87445 -14.5067 3.75712 -6822 6 21.6604 35.221 23.9985 9.0652 15.9564 -12.6156 -6823 4 21.5339 34.4977 24.6161 5.50034 -7.33202 6.93593 -6824 4 22.5891 35.5406 24.0132 -10.9025 -9.97729 6.37443 -6825 6 8.25067 41.5023 8.40693 4.57396 0.593767 -7.67714 -6826 4 8.14583 40.8128 7.73311 1.23406 2.32353 -0.157563 -6827 4 7.86929 41.1416 9.20784 -2.18245 3.41182 6.12515 -6828 6 16.4756 31.0916 22.2208 -15.8048 -5.76047 -3.57767 -6829 4 16.9823 30.8797 21.4186 0.224111 -1.11381 3.57708 -6830 4 17.0871 31.1495 22.9566 10.3822 -1.94934 1.40451 -6831 6 54.7052 0.441622 28.3216 30.4392 7.42547 7.16367 -6832 4 0.670225 0.280878 28.2941 -2.60978 -25.0778 -11.1355 -6833 4 54.7831 1.35385 28.5964 -22.0828 12.0381 3.63841 -6834 6 48.4365 15.3814 4.18175 16.1137 -59.8395 -8.29881 -6835 4 49.2486 15.0627 4.66696 -19.7577 20.5705 -9.22457 -6836 4 48.202 14.5739 3.61717 1.65501 39.0327 16.4105 -6837 6 34.3447 6.98096 40.4233 28.1894 -26.1309 -0.966046 -6838 4 33.5941 7.1072 39.8443 -1.28272 -2.58724 -7.46065 -6839 4 35.0352 6.39393 39.9745 -30.768 20.5054 8.50532 -6840 6 41.3452 3.36617 16.9999 -11.8967 -16.9054 2.63506 -6841 4 41.0249 2.72492 17.6694 2.1854 6.18106 -7.89089 -6842 4 41.9449 3.92974 17.49 7.08552 9.22633 4.28017 -6843 6 48.4488 20.6937 14.5344 36.1561 -40.2628 27.2518 -6844 4 47.9962 21.3635 14.0898 -25.7182 45.1623 -29.349 -6845 4 49.3977 20.8911 14.4834 -7.22111 0.680744 -3.09477 -6846 6 52.5006 28.1422 37.1181 -0.438891 10.9489 1.55023 -6847 4 53.461 28.2559 37.0441 -2.53591 -5.73983 -7.32344 -6848 4 52.1579 27.9957 36.2188 6.05301 2.29627 6.02383 -6849 6 53.8778 18.5596 18.7916 -16.4261 -54.6782 2.06415 -6850 4 54.6924 18.1462 18.492 5.89253 -2.608 -0.931268 -6851 4 54.0684 19.4623 18.7843 11.279 55.5152 0.463912 -6852 6 40.9954 39.1455 28.7887 -28.6383 -4.85259 53.4888 -6853 4 41.3933 39.2419 27.9663 30.849 7.00679 -57.5311 -6854 4 40.0484 39.2316 28.6375 -4.32997 -1.25138 -0.266272 -6855 6 38.2708 8.75593 24.2289 27.2886 -4.9888 -5.43324 -6856 4 39.2171 8.59021 23.9715 -26.3742 3.09491 7.04217 -6857 4 38.3303 9.34105 24.9905 -3.83131 2.71498 5.53525 -6858 6 2.99948 29.1469 9.63392 26.6909 -34.1608 2.5373 -6859 4 2.51216 28.7995 8.89273 -4.75194 -2.8028 -9.24178 -6860 4 2.58111 29.9575 9.82954 -15.8869 33.6035 13.3424 -6861 6 27.5773 29.2771 18.3181 4.27818 -11.5166 33.1226 -6862 4 26.7531 29.1546 17.8331 -9.3021 -0.872639 -4.78576 -6863 4 27.3558 28.9731 19.2647 9.0806 12.9475 -44.783 -6864 6 11.8527 21.1658 10.1208 3.44892 -32.1211 19.512 -6865 4 12.1978 22.0146 9.89711 8.39983 22.4635 -8.03232 -6866 4 12.4593 20.8304 10.8135 -12.0936 9.66798 -13.0295 -6867 6 16.8988 32.3014 0.299949 1.29982 1.68058 -0.586211 -6868 4 17.7043 32.7282 0.600499 13.9817 -1.747 3.00212 -6869 4 16.3216 33.0562 0.17902 -12.1561 7.80428 -5.7129 -6870 6 1.309 17.4831 22.5447 23.3848 -11.3219 -15.6007 -6871 4 1.13597 16.5744 22.1718 3.15619 19.2398 8.80125 -6872 4 2.27868 17.6899 22.4311 -25.7511 -7.40397 3.71946 -6873 6 41.5587 6.87311 29.3039 4.08196 29.5448 1.53382 -6874 4 41.6919 5.95311 29.5356 2.80206 -5.98386 3.69024 -6875 4 41.9106 7.40602 30.0483 -3.99043 -10.4039 -5.51054 -6876 6 10.5167 10.7886 13.8618 17.7458 -17.1897 13.2051 -6877 4 10.6632 11.2096 13.003 1.79898 0.261401 -4.84225 -6878 4 11.2159 10.1 14.0373 -16.1376 17.4326 -7.31573 -6879 6 39.8332 15.4952 40.8309 13.3581 4.75609 3.89566 -6880 4 39.9392 16.0809 40.0548 0.3292 -3.56753 7.15077 -6881 4 40.6564 15.5643 41.3732 -15.0531 5.58747 -11.8726 -6882 6 26.5094 19.6057 40.5003 9.17758 -2.41024 9.24949 -6883 4 27.4312 19.885 40.5187 -1.32295 2.31326 -8.74715 -6884 4 26.4504 19.08 41.3172 -10.7617 -0.025449 -2.36491 -6885 6 54.0331 8.19348 13.7645 20.1265 23.4755 -3.20859 -6886 4 54.5379 7.42769 14.0195 10.1236 -9.46733 3.3174 -6887 4 53.1635 7.89609 13.5919 -33.2862 -9.18344 -4.84573 -6888 6 15.685 25.3343 10.6639 3.77823 -5.01457 0.699023 -6889 4 15.2925 25.3549 9.7704 -6.94194 -0.507815 8.78718 -6890 4 14.9859 25.2981 11.3464 3.26271 -0.250944 -15.837 -6891 6 18.6044 3.42728 21.9359 54.0117 -4.17358 13.1129 -6892 4 19.6007 3.50499 22.1915 -55.8621 -1.2706 -18.0159 -6893 4 18.5414 3.70523 21.0018 -0.6471 0.781857 10.4283 -6894 6 50.8906 20.6382 18.514 19.322 19.8933 14.7131 -6895 4 50.0771 21.0514 18.1693 2.40506 3.30677 2.13188 -6896 4 51.4314 21.2881 19.0676 -26.3068 -18.4046 -20.3942 -6897 6 53.3692 20.9044 31.2861 -2.87581 -0.0590227 -4.61483 -6898 4 53.3163 20.8663 32.2507 -1.10677 -1.05899 -2.14121 -6899 4 52.4655 20.8115 30.924 8.48272 0.484508 7.85381 -6900 6 52.8175 27.637 28.9992 -34.1073 -16.3293 -5.23745 -6901 4 52.1753 27.4604 29.7292 18.9476 13.4611 -8.14668 -6902 4 53.5412 28.184 29.256 17.7352 16.912 19.7012 -6903 6 33.3098 15.691 11.3293 10.3241 5.44869 29.2776 -6904 4 33.5439 15.9761 12.2647 -8.49351 -12.0766 -30.078 -6905 4 32.4682 16.1118 11.1139 -1.38634 1.49203 3.14806 -6906 6 20.3823 26.792 27.4754 10.6616 14.7237 17.2289 -6907 4 19.6846 27.4135 27.2507 -4.69437 -0.849554 -6.03625 -6908 4 20.895 27.2908 28.1563 -10.3656 -18.3754 -15.2612 -6909 6 8.54404 2.05454 14.1651 1.1449 13.7122 2.29602 -6910 4 8.12946 1.19872 14.2191 -6.02545 -13.9865 0.607463 -6911 4 8.06484 2.58201 14.8308 4.74922 -3.38849 -5.44478 -6912 6 40.1105 7.56396 40.6794 -0.469697 6.72942 -1.63666 -6913 4 39.7195 8.28533 41.2425 20.0171 -18.0739 -7.27063 -6914 4 40.8018 7.03949 41.1472 -13.6242 13.5344 3.71207 -6915 6 6.897 6.83213 10.7811 7.71606 15.0782 -3.77655 -6916 4 7.19774 7.75246 10.6132 -6.74961 -17.2243 4.00207 -6917 4 7.00156 6.6927 11.7358 -2.06706 0.697676 -4.80225 -6918 6 31.2469 6.57665 20.133 15.2512 -44.8317 5.05575 -6919 4 30.6435 5.99888 20.634 -3.65198 3.16249 1.16613 -6920 4 30.7682 7.35458 19.9689 -22.0921 35.6742 -6.0398 -6921 6 54.5384 21.0446 27.3066 23.2273 -48.3206 40.5729 -6922 4 0.0992734 20.2122 27.4067 -21.2046 24.987 7.15799 -6923 4 54.6588 21.2398 26.4073 -2.82622 20.9035 -45.5707 -6924 6 4.74298 23.1434 16.2203 -30.2995 19.4891 -12.6787 -6925 4 4.36556 24.0555 16.215 7.46998 -18.526 0.357752 -6926 4 5.49124 23.2367 16.7883 23.1348 -5.45784 14.6166 -6927 6 25.5466 11.0338 14.8277 10.3359 0.700294 4.3384 -6928 4 26.1246 10.3443 15.2243 -8.70528 11.4294 -11.7317 -6929 4 25.9183 11.8873 15.0941 -0.865353 -5.34287 -3.41216 -6930 6 41.1962 41.784 29.9422 -30.017 -5.50367 -10.8152 -6931 4 40.9141 40.905 29.5845 10.5201 22.1914 8.67773 -6932 4 40.3904 0.453034 29.9085 19.4524 -11.6054 2.3136 -6933 6 52.2783 15.2862 41.6211 7.07203 -4.19206 -10.8941 -6934 4 51.9431 15.9476 0.307056 -1.67854 11.1856 8.97788 -6935 4 51.5699 14.6487 41.5543 -8.05659 -11.9472 -4.98288 -6936 6 37.758 21.7866 37.8526 10.4754 12.291 4.40187 -6937 4 37.8833 20.8525 37.7239 2.64231 -18.5298 -3.43162 -6938 4 38.1062 21.9123 38.7409 -0.189838 4.59809 2.45253 -6939 6 23.846 9.72877 27.5599 -20.0483 -53.0743 -18.3837 -6940 4 23.7508 8.9538 26.878 9.78252 41.145 35.6193 -6941 4 23.2758 9.50619 28.3397 9.82275 7.24107 -18.911 -6942 6 43.0179 28.0371 32.8168 -8.27592 12.0689 -0.875134 -6943 4 42.8326 27.1827 33.2413 14.9994 1.75302 -2.99965 -6944 4 43.9358 28.1723 32.5349 -8.32605 -13.2452 6.20231 -6945 6 34.1493 21.223 11.895 -6.4617 -26.4803 6.62596 -6946 4 33.7114 20.3967 12.2433 5.74917 23.5867 -12.2191 -6947 4 33.6625 21.5015 11.0997 -1.34318 -2.64619 5.02085 -6948 6 10.5048 31.8203 10.0934 3.12763 27.8567 -5.97475 -6949 4 10.8893 32.6663 10.3856 -2.25958 -16.5293 2.97323 -6950 4 10.042 32.0955 9.27903 1.62317 -10.8132 6.61598 -6951 6 35.8582 37.1311 22.1219 17.442 6.8165 -15.3109 -6952 4 36.7754 37.4644 22.0121 -13.2022 -8.29883 -6.66499 -6953 4 35.6795 37.2674 23.0383 -11.5038 0.0185045 25.2366 -6954 6 27.2889 4.59659 27.4585 -59.4895 -12.2555 32.2126 -6955 4 27.8503 4.63259 28.2407 7.94553 1.46958 -1.61102 -6956 4 26.3513 4.38137 27.8533 49.6255 8.2673 -26.6042 -6957 6 39.0071 22.2889 10.6559 -18.7539 6.55471 8.53947 -6958 4 39.6145 22.0219 9.97399 11.0637 -4.63202 -10.5583 -6959 4 38.132 22.2267 10.2407 1.98377 -6.13574 3.6668 -6960 6 30.7475 39.195 10.9378 13.4076 -25.4475 -2.13886 -6961 4 31.7135 39.1987 10.9202 1.84768 25.2682 1.10777 -6962 4 30.6542 38.2342 10.8274 -15.9936 9.0572 -1.5893 -6963 6 44.6038 26.9469 2.19596 -3.02312 -2.7981 0.496435 -6964 4 44.789 26.0668 2.58199 4.34993 15.1048 -14.5643 -6965 4 45.3477 27.2287 1.63769 1.54159 -5.20589 8.29494 -6966 6 23.7761 14.5574 26.4892 -1.60295 28.5342 -20.4107 -6967 4 23.6176 15.1119 25.659 4.49284 -25.3407 28.839 -6968 4 23.2395 13.7622 26.4238 -2.18231 -2.53609 -2.40557 -6969 6 38.3444 13.3746 39.6516 36.4054 -1.80378 3.51049 -6970 4 39.1202 13.8805 40.0461 -33.1028 -11.4882 -12.1373 -6971 4 37.5326 13.855 39.8351 -2.35218 5.60767 6.28087 -6972 6 17.8972 17.2344 29.4073 9.50877 -9.96512 10.1834 -6973 4 17.6974 16.8197 28.5593 -3.90288 0.722299 -3.3346 -6974 4 17.259 17.9348 29.5179 -13.7448 8.39178 0.729907 -6975 6 17.4263 29.84 9.91085 4.63967 13.4244 18.4952 -6976 4 16.5241 29.7155 9.63978 -6.68442 -7.79832 -10.641 -6977 4 18.0121 29.6473 9.18714 6.17675 -5.88453 -9.84082 -6978 6 35.6257 6.05657 19.614 -2.53427 -7.67526 1.74575 -6979 4 35.1442 5.56448 18.9178 7.07991 15.7277 0.668344 -6980 4 35.8526 6.94177 19.2847 -2.44106 -6.98166 -5.33042 -6981 6 18.6731 22.2952 17.5195 -8.35574 4.99894 -0.254983 -6982 4 17.7298 22.4259 17.6349 -7.1371 0.699885 10.6378 -6983 4 18.7532 22.3981 16.578 9.97204 2.32932 -16.3296 -6984 6 20.0126 3.82895 32.2846 -5.38506 7.6032 10.998 -6985 4 19.7316 4.05659 31.3951 3.95105 0.959407 -6.40709 -6986 4 20.9087 3.45699 32.2166 -3.62371 1.18893 -2.87546 -6987 6 5.48106 6.97474 8.11911 -13.3431 -28.5569 -4.23146 -6988 4 5.76723 7.87539 8.05126 9.5873 19.9723 5.64469 -6989 4 5.84003 6.56862 8.91875 4.365 4.20298 7.41399 -6990 6 44.2055 20.527 25.594 -36.5422 -32.7496 -22.1294 -6991 4 44.4952 21.1964 26.2048 27.2712 12.1663 0.509182 -6992 4 44.8136 20.1687 24.9192 13.264 16.717 13.5958 -6993 6 43.9676 36.9898 17.8707 9.43563 13.9581 11.3899 -6994 4 44.6425 37.4866 17.3506 -13.9886 -14.2814 1.04264 -6995 4 43.5166 36.316 17.3518 1.57776 -4.71986 -9.07493 -6996 6 34.624 10.1249 16.2553 -3.80507 -0.870494 -23.8528 -6997 4 34.4029 10.0232 15.2766 7.60873 7.05542 33.3523 -6998 4 34.6485 11.0843 16.4397 0.136369 -4.79707 -6.11079 -6999 6 23.6588 3.43472 1.31587 2.0947 2.20184 -10.1691 -7000 4 23.5283 2.45383 1.23665 3.68597 29.2686 -10.0862 -7001 4 23.7829 3.95594 0.465507 -5.48879 -27.0668 21.3429 -7002 6 33.408 38.9514 5.0951 12.9752 29.4037 8.61745 -7003 4 33.0296 38.079 4.95882 -18.4714 -2.71742 3.9597 -7004 4 32.7559 39.6696 5.33685 4.56028 -29.4715 -9.24259 -7005 6 22.5612 32.5054 35.7914 -7.59797 17.3543 -6.08959 -7006 4 23.434 32.1498 35.9581 8.59623 -0.183209 1.98348 -7007 4 22.6598 33.4814 35.6698 2.01652 -18.126 2.22848 -7008 6 32.4197 37.2669 13.8205 20.7322 22.1346 -9.91782 -7009 4 31.6112 36.8955 13.5272 -29.3682 -10.7083 -8.61391 -7010 4 32.7793 36.5983 14.3861 8.71878 -17.2052 10.8721 -7011 6 52.6061 12.7509 39.5955 -8.08982 -5.36768 -0.728302 -7012 4 53.2357 13.3696 39.2333 6.80499 9.05338 -6.44134 -7013 4 53.0752 12.2813 40.2869 4.34006 -2.9945 3.85342 -7014 6 28.8406 14.5639 1.22393 13.2702 13.2594 -7.07732 -7015 4 28.2547 13.832 1.29641 -8.98786 -23.9917 -3.18497 -7016 4 28.3081 15.2705 1.57856 0.691728 8.20301 3.76967 -7017 6 1.46371 32.4171 23.3808 -12.1734 -25.5645 13.9938 -7018 4 1.52421 31.5049 23.0145 7.51613 19.861 -1.66683 -7019 4 1.90409 33.05 22.8306 10.4998 5.06095 -20.3958 -7020 6 54.3326 23.3294 28.9734 2.61182 15.3833 -1.51239 -7021 4 54.2696 22.9227 29.8387 -0.130455 -4.55084 5.05008 -7022 4 54.4476 22.6226 28.3359 -0.0534198 -9.82677 -0.516761 -7023 6 14.3165 12.143 35.6759 -19.2415 -8.81627 -0.503167 -7024 4 14.3877 12.7977 36.3527 0.233596 18.6669 11.2481 -7025 4 15.2077 11.8775 35.5438 25.0768 -7.98239 -7.51161 -7026 6 18.9926 6.51479 41.2701 -28.9824 -29.6237 1.81046 -7027 4 18.266 5.84223 41.3522 13.7729 17.3268 -5.20094 -7028 4 19.3309 6.57432 0.258232 8.64619 7.1183 4.95474 -7029 6 5.3156 17.8978 20.3375 -21.1545 16.5991 3.60383 -7030 4 4.72623 18.3448 19.6879 4.29754 -5.05212 8.41069 -7031 4 4.82948 17.9368 21.1935 9.1049 1.98802 -15.8618 -7032 6 24.7216 34.9676 30.1666 -3.07326 -14.2394 -14.8574 -7033 4 24.8542 35.9126 30.1802 4.14387 12.0412 4.3338 -7034 4 24.7023 34.7085 29.2239 -0.0690866 8.67132 12.606 -7035 6 31.8759 4.61762 18.1838 16.2734 -6.94643 -1.61547 -7036 4 31.7767 5.32612 18.8146 -0.693712 9.66586 8.6442 -7037 4 30.9961 4.53608 17.8264 -12.7431 -2.99311 -6.3499 -7038 6 8.70679 17.4876 5.93376 -7.2594 15.0659 3.57914 -7039 4 7.94553 18.1226 5.84491 19.4684 -9.25267 2.2845 -7040 4 9.55198 17.9922 5.98984 -15.4384 -2.82622 -0.0668602 -7041 6 29.8338 10.9771 14.4736 2.85583 -20.8689 4.17621 -7042 4 29.3487 11.4359 13.7779 -2.35633 12.0716 2.99849 -7043 4 29.9333 11.5067 15.2792 -5.11986 9.15119 -1.36774 -7044 6 48.7176 10.2992 32.5766 37.752 -4.2965 -7.5649 -7045 4 48.6861 9.98692 33.5109 4.36425 8.41374 -15.5521 -7046 4 49.6689 10.1741 32.2115 -43.6207 3.75412 17.6406 -7047 6 8.33261 15.6868 37.8739 25.2856 -16.7599 -34.932 -7048 4 8.10095 16.0156 38.719 -17.2941 17.7495 29.2541 -7049 4 7.84865 16.1686 37.1872 -4.77393 6.83012 10.4818 -7050 6 50.4 3.07893 17.326 6.75193 2.54677 -10.5223 -7051 4 49.8476 3.08454 16.5614 0.0537611 0.514048 -24.7797 -7052 4 49.7563 3.22783 17.9993 -5.52918 6.4504 35.6689 -7053 6 14.6925 38.3995 10.8943 -10.4545 -11.2686 -1.07851 -7054 4 14.3539 38.6226 11.7634 0.533319 14.8424 10.3104 -7055 4 14.2274 37.5681 10.7419 5.82896 -0.087222 -8.72758 -7056 6 34.1157 6.37736 10.827 20.4112 17.5403 9.63945 -7057 4 34.1356 7.15575 10.2337 -4.79421 -13.4894 2.09643 -7058 4 34.9392 6.47467 11.3721 -17.4677 -2.57189 -8.67394 -7059 6 7.16428 37.5549 17.6272 35.8206 -6.94283 1.42456 -7060 4 8.17672 37.4379 17.5039 -45.4701 3.04153 9.54579 -7061 4 6.9329 37.0909 18.4673 4.48983 7.2965 -12.9876 -7062 6 51.5173 11.3068 16.7982 -29.6345 12.4732 -19.9425 -7063 4 52.2329 10.8476 17.1999 24.0623 -16.8016 7.00331 -7064 4 51.4947 11.1437 15.8343 5.46468 -1.37513 9.57578 -7065 6 15.6604 8.64432 3.1895 3.55656 -13.2601 -18.336 -7066 4 15.3831 9.26805 3.84437 -11.3932 20.6181 15.5674 -7067 4 16.2117 8.03967 3.68493 6.317 -8.49687 -0.892024 -7068 6 5.4241 21.4549 11.925 7.11554 10.6798 -7.02681 -7069 4 5.33432 22.3429 11.4717 -4.65036 -17.889 17.4658 -7070 4 4.77116 21.2815 12.6313 -0.367847 15.68 -7.67111 -7071 6 50.1893 24.0442 37.9781 -13.1484 0.855785 -17.0816 -7072 4 49.5179 24.1845 37.2801 8.13829 0.111989 16.6227 -7073 4 50.739 23.3224 37.6715 2.2014 -1.01472 3.1635 -7074 6 39.7382 11.2507 31.6977 23.6406 7.23187 -3.58891 -7075 4 40.4046 11.8538 31.2923 -18.8268 -10.2166 5.80002 -7076 4 38.8713 11.6238 31.5229 -1.54541 8.70996 -4.13134 -7077 6 26.6923 10.8294 20.5841 1.50171 17.3672 -0.163562 -7078 4 26.3063 11.3901 21.299 5.00814 -17.7696 -11.6362 -7079 4 26.5519 9.91114 20.8376 -1.99146 -0.979444 5.82041 -7080 6 12.5744 17.5779 18.1705 9.62673 -31.396 -11.9521 -7081 4 12.2909 16.663 17.987 19.11 1.74385 -8.92353 -7082 4 11.8345 17.8227 18.6757 -30.0259 29.7826 25.4081 -7083 6 47.7778 31.6094 17.3292 -7.10666 -17.038 -8.06235 -7084 4 48.347 31.2547 18.014 2.28217 1.30733 4.94459 -7085 4 47.3418 30.8212 16.9416 1.10301 17.3121 -1.07651 -7086 6 1.06524 3.39018 18.5298 -14.3894 10.3619 10.5476 -7087 4 1.40487 3.81402 19.3241 14.4239 4.64695 -0.395869 -7088 4 0.13491 3.28998 18.7837 -2.56119 -4.67364 -10.5163 -7089 6 26.5953 20.387 15.3121 4.86749 -24.5982 -5.101 -7090 4 27.0693 19.5476 15.0746 -6.18915 17.8108 6.48343 -7091 4 25.6882 20.059 15.4501 7.15985 4.40883 -1.86988 -7092 6 42.0068 3.03472 36.7639 -8.02624 -14.3838 3.82934 -7093 4 41.5138 2.21919 36.6422 -1.8797 -9.24856 -19.1073 -7094 4 41.9017 3.12445 37.6992 6.42334 14.3979 20.8626 -7095 6 39.3283 22.4329 33.1866 16.7976 22.9312 16.1168 -7096 4 39.617 22.6043 34.1233 -9.1007 -15.4059 -24.4851 -7097 4 39.2996 23.351 32.8579 -1.9326 -13.3537 -7.72798 -7098 6 18.5014 34.9723 11.9503 -40.872 8.93582 -22.0032 -7099 4 19.313 34.895 12.3871 37.9781 -3.12322 33.9295 -7100 4 17.8134 35.1232 12.6133 -0.0311416 1.40314 8.7121 -7101 6 22.862 14.1089 0.203393 17.2545 -2.37957 19.5806 -7102 4 23.1276 14.8054 41.5255 0.219481 9.03583 -13.3452 -7103 4 23.4003 14.3117 0.999915 -8.23864 -6.67581 -7.59618 -7104 6 30.9898 16.6325 33.7811 -26.24 4.82889 -18.7278 -7105 4 30.4991 16.9295 32.9906 -1.06726 -7.21679 15.5744 -7106 4 31.8724 16.8786 33.545 20.2345 1.84197 6.64809 -7107 6 28.4142 35.5086 5.55132 5.25795 11.5001 -0.86936 -7108 4 29.133 34.8901 5.6729 7.87573 -11.0207 0.32142 -7109 4 28.8444 36.3678 5.44284 -5.96253 -1.38672 0.306744 -7110 6 2.06178 31.4487 10.6522 7.7724 2.5252 5.43788 -7111 4 2.46787 32.1741 10.1582 1.48866 -1.05725 0.00513454 -7112 4 1.12423 31.5492 10.4902 -10.7705 -1.69396 -4.48797 -7113 6 5.96168 9.75465 21.3469 -3.89643 8.81348 -50.5901 -7114 4 6.28958 10.5041 20.7544 -9.04712 -29.7196 22.9081 -7115 4 5.37557 9.21645 20.7377 15.5825 17.9805 22.1648 -7116 6 24.7784 26.6095 2.66066 11.1746 -2.24162 5.28408 -7117 4 23.9956 26.7754 2.10108 -2.29597 -10.0774 9.56872 -7118 4 24.6953 25.8682 3.30791 -10.2989 11.7132 -14.8816 -7119 6 45.7373 4.24983 18.6143 27.3178 -0.763462 -4.2154 -7120 4 46.5067 4.85242 18.4954 -19.0177 -2.03966 3.70694 -7121 4 46.1538 3.38182 18.4484 -14.6954 3.88493 3.6473 -7122 6 4.46307 0.776675 15.9004 -0.0751459 19.7124 -7.24544 -7123 4 4.28648 41.7452 15.8506 7.90268 -11.6504 4.49907 -7124 4 5.34722 0.941656 16.2766 -7.84 -9.44871 -1.18019 -7125 6 2.43543 19.4835 25.3975 -8.02289 7.34849 22.5637 -7126 4 1.8039 19.0427 26.0095 9.34608 -2.48106 -16.7091 -7127 4 2.63666 18.9452 24.6346 -2.8512 -10.1259 -3.82486 -7128 6 40.5893 8.48301 5.11314 -1.35782 -12.8068 -2.32465 -7129 4 40.7524 9.27543 5.61119 -3.30667 17.7402 10.4879 -7130 4 41.4486 8.05286 5.16027 3.34022 -8.8045 -8.92488 -7131 6 49.3107 22.3512 41.5276 -10.6582 56.3201 6.76971 -7132 4 48.577 22.7852 41.0387 15.264 -8.60422 5.01334 -7133 4 49.2575 21.458 41.2835 -0.448838 -46.7272 -11.6484 -7134 6 0.358901 40.9209 20.5803 -19.8443 -5.20423 -21.0143 -7135 4 0.209912 39.9476 20.5616 0.00996972 10.506 -0.843682 -7136 4 54.6254 41.351 20.0384 15.1519 -13.0167 14.2251 -7137 6 34.868 15.3449 38.0159 -4.77394 11.9701 -21.6163 -7138 4 34.21 16.0699 37.905 14.1938 -11.5268 -7.28032 -7139 4 35.478 15.4115 37.2329 -18.0572 6.07255 16.3223 -7140 6 7.76403 26.0071 29.8556 5.34791 -0.957035 4.21351 -7141 4 8.62364 26.4528 30.0224 -8.82329 -12.5157 -0.945539 -7142 4 7.90301 25.0604 30.0866 1.23738 19.4493 -2.25897 -7143 6 40.714 22.798 20.4449 30.2403 28.6605 -20.1452 -7144 4 41.3584 23.4838 20.081 -22.4198 -29.1089 11.875 -7145 4 40.2102 23.3285 21.0558 -12.075 4.18803 12.4472 -7146 6 37.6868 25.6422 36.0641 6.66209 -5.59755 13.6904 -7147 4 38.2808 24.8923 36.0269 4.65063 -3.44496 7.57849 -7148 4 37.3429 25.6351 35.1859 -16.0941 8.70932 -25.1352 -7149 6 5.45062 23.9828 10.2587 5.16865 5.9624 5.01697 -7150 4 5.97911 23.8188 9.45867 -6.21725 4.51436 8.29683 -7151 4 5.82702 24.8173 10.6422 -10.2102 -24.7042 -13.9856 -7152 6 48.3972 21.0585 38.1887 36.079 14.8531 -15.9941 -7153 4 48.9083 20.6932 38.9203 -9.15007 -3.24726 4.47194 -7154 4 49.1186 21.3212 37.5505 -33.8036 -6.43701 14.9947 -7155 6 15.2894 25.0118 3.53737 -15.5341 -16.8072 10.9824 -7156 4 15.3523 24.0463 3.54635 7.80908 -0.218079 -10.1213 -7157 4 14.6524 25.152 4.25109 -0.971191 12.1275 -1.41446 -7158 6 46.3973 40.2818 20.0864 -5.10979 -28.8528 0.810189 -7159 4 46.7099 39.3289 20.1836 -4.69047 35.7762 -3.66479 -7160 4 47.1343 40.8792 20.2285 11.4236 3.93541 -0.385178 -7161 6 34.6613 36.4755 0.335066 -24.7851 30.4749 -21.6933 -7162 4 34.8743 36.0541 1.15687 -4.43901 -4.57192 24.0914 -7163 4 33.7851 36.9546 0.454416 30.1492 -20.7825 2.99091 -7164 6 52.5881 7.99834 30.4195 9.51271 -12.4348 0.483116 -7165 4 52.1042 8.76616 30.7719 -8.49213 -7.21741 -10.9068 -7166 4 52.0722 7.46347 29.7764 0.520668 12.6171 10.1624 -7167 6 32.0714 3.86484 29.4697 -9.7538 -17.9077 -31.6249 -7168 4 31.6702 2.97314 29.6052 7.93851 20.6113 2.31556 -7169 4 32.0839 3.94733 28.4741 0.539668 -3.17995 32.4864 -7170 6 20.3786 17.8365 28.6466 -12.59 16.0252 -12.2548 -7171 4 19.5397 17.5939 29.0718 10.0495 1.57584 1.91854 -7172 4 20.0545 18.3008 27.843 10.529 -6.18443 10.1885 -7173 6 30.4085 41.1704 41.0135 6.18506 -3.22706 -14.2809 -7174 4 30.53 40.7341 40.1581 -10.3332 2.11637 -0.589059 -7175 4 31.2241 40.9477 41.4498 10.7912 2.88832 12.9661 -7176 6 35.4567 32.8541 27.9296 20.1033 20.3116 -25.2142 -7177 4 35.1103 33.2872 28.7174 -1.27312 4.66796 4.01126 -7178 4 35.9087 33.5476 27.342 -15.0191 -24.2746 21.4934 -7179 6 14.3794 6.67806 12.7301 -1.9413 28.2373 -4.00169 -7180 4 15.2373 6.26429 12.8613 2.01848 -2.11516 -0.858514 -7181 4 14.5332 7.65903 12.7289 -3.54891 -27.4927 -2.87641 -7182 6 41.884 41.5441 20.3292 17.5267 3.97767 -7.39307 -7183 4 42.6467 41.3531 19.7473 -6.80228 5.43899 6.41045 -7184 4 41.2989 40.8038 20.1922 -8.54368 -4.96293 -3.75352 -7185 6 46.4016 22.5784 8.86191 7.75251 -10.6521 7.11129 -7186 4 45.8476 21.8716 8.52158 -12.3576 2.35246 -8.51817 -7187 4 47.0146 22.0703 9.39636 1.75986 6.35736 5.22437 -7188 6 17.4049 20.6472 13.8946 9.03444 14.2526 1.49725 -7189 4 17.6929 21.5842 14.0543 -8.3446 -25.4959 -7.46489 -7190 4 17.3265 20.4984 12.9333 2.034 6.01629 5.63707 -7191 6 8.18883 9.49722 13.352 -36.2403 7.79383 -0.838203 -7192 4 7.38606 10.0563 13.5919 32.9103 -12.129 -3.09847 -7193 4 9.02271 9.90793 13.6245 -5.40631 9.4956 5.41337 -7194 6 7.5857 14.8045 29.5864 0.660595 8.18183 -2.22865 -7195 4 7.08502 14.4366 30.3218 -1.52277 2.83209 3.37304 -7196 4 7.02502 15.474 29.1565 2.15616 -5.78955 1.98978 -7197 6 29.5787 39.2199 22.642 -23.9064 2.77655 4.40715 -7198 4 29.7923 38.7231 23.4359 12.3113 -5.95711 5.92816 -7199 4 30.3289 39.2945 22.0576 16.6647 -3.01011 -3.30282 -7200 6 19.7261 28.8048 8.43629 7.07867 10.1416 -1.30332 -7201 4 19.5094 27.8711 8.56662 5.24428 2.50367 -2.7317 -7202 4 20.6808 28.8901 8.64157 -12.3267 -4.04756 -0.658665 -7203 6 20.0918 21.6433 25.9098 -22.8378 18.9737 -2.62589 -7204 4 20.6828 21.9331 26.6394 -14.5657 0.991195 -11.6344 -7205 4 19.2872 22.2354 25.9429 24.6623 -16.2361 5.64257 -7206 6 12.7798 16.1171 22.7918 2.83481 -1.66518 -8.4999 -7207 4 12.1052 16.761 22.5802 -5.26913 11.1277 0.000470885 -7208 4 12.4145 15.3113 22.3987 5.67676 1.62415 3.74644 -7209 6 7.09341 27.2127 17.9852 -17.6727 17.6357 -2.43489 -7210 4 7.71878 26.5086 17.8851 15.5779 -18.3258 -2.50971 -7211 4 7.24623 27.7931 17.2297 2.82114 0.873921 -0.89624 -7212 6 32.4121 8.69011 34.8574 -11.3856 31.068 25.9423 -7213 4 32.686 9.10208 35.716 -2.62469 -14.8204 -24.695 -7214 4 31.4981 9.04705 34.7249 20.8054 -13.4625 -4.53694 -7215 6 50.3489 28.2274 17.5408 2.96892 -19.9668 3.87059 -7216 4 50.2931 27.3328 17.9381 -3.71715 13.2344 -0.552608 -7217 4 51.012 28.0828 16.8476 -2.81747 8.99858 -3.49204 -7218 6 15.6752 32.1523 25.7996 -24.1097 -1.02752 -8.0065 -7219 4 16.4469 32.5721 26.1513 19.1192 7.47953 7.03048 -7220 4 15.1241 32.8942 25.4834 5.39501 -5.59697 3.80799 -7221 6 41.2942 22.0009 29.6469 23.8016 -11.3242 12.4312 -7222 4 40.6197 22.5451 29.2897 -20.6362 19.5621 -14.8771 -7223 4 40.8321 21.2604 30.0334 -1.27155 -6.80964 4.85239 -7224 6 24.5512 12.7478 8.87624 0.539479 -2.56763 -16.1827 -7225 4 24.2317 13.5544 9.29419 1.48927 0.294937 0.678301 -7226 4 24.2485 12.8104 7.9491 4.47413 -5.17195 11.4459 -7227 6 47.3043 20.1171 10.4067 20.0451 13.2477 8.4905 -7228 4 48.2327 20.3756 10.3708 -0.951507 4.56311 9.88278 -7229 4 47.2371 19.5522 9.64912 -14.6685 -17.4861 -17.2657 -7230 6 17.6686 14.2187 29.9453 7.31834 -6.07886 -8.28437 -7231 4 16.8567 14.6777 30.1627 -12.3548 11.6861 -0.426412 -7232 4 18.1621 14.7508 29.3045 -6.68566 0.573373 4.02912 -7233 6 21.3468 34.5864 28.5404 1.3464 21.7174 -7.002 -7234 4 21.5866 35.4807 28.2285 -6.04705 -7.23946 1.73439 -7235 4 21.8012 34.5133 29.372 6.90897 -8.71765 12.9147 -7236 6 35.0919 4.05058 4.01374 -15.5825 9.30565 11.5721 -7237 4 34.2387 3.74233 4.43927 22.4566 16.9059 -11.4445 -7238 4 35.1406 5.04582 3.93988 -11.3656 -25.7387 7.52347 -7239 6 29.9083 8.58745 22.5962 -15.8002 1.46007 -28.7439 -7240 4 29.4293 8.33193 21.7391 23.5037 3.33824 36.5279 -7241 4 30.4512 7.83881 22.8901 -6.5033 3.48596 -7.29863 -7242 6 9.80484 32.9578 15.933 -3.40746 -8.77641 -12.0557 -7243 4 9.78146 31.9986 16.1651 13.0086 23.7442 4.23133 -7244 4 10.4547 33.4728 16.4465 2.19651 -19.1398 5.78046 -7245 6 24.9207 14.2283 32.5839 15.8568 -2.03515 22.8032 -7246 4 25.4679 14.491 33.3602 -10.7028 -6.65113 -14.6818 -7247 4 24.5651 15.0495 32.2637 -5.99659 7.67207 -7.30645 -7248 6 49.6599 21.9679 26.2292 42.3899 27.0609 3.31449 -7249 4 50.4576 21.5325 26.6526 -24.3124 13.7703 -9.69582 -7250 4 49.9726 22.89 25.9802 -16.6307 -33.6109 8.97028 -7251 6 39.2146 29.6271 28.776 1.2649 -6.72815 -4.66326 -7252 4 39.3113 29.0399 29.5368 -1.10705 1.67847 4.24024 -7253 4 39.5646 29.0864 28.052 -0.275695 2.9096 0.748968 -7254 6 50.692 34.7829 39.7485 29.9384 -8.83369 -9.14761 -7255 4 51.6379 34.6172 39.5245 -10.9597 10.0847 13.0799 -7256 4 50.284 34.1892 39.1195 -14.598 -6.88033 -5.74908 -7257 6 29.205 20.8761 19.5187 12.6622 -8.88768 18.517 -7258 4 30.1458 21.1462 19.5468 -10.0278 2.51211 -7.13483 -7259 4 28.7621 21.2804 18.7794 -5.02457 12.868 -15.5739 -7260 6 45.8413 1.41619 21.3894 -25.1775 13.0352 -19.0829 -7261 4 45.002 1.0285 21.6935 10.996 -3.183 3.42833 -7262 4 46.5512 0.981978 21.8333 16.3199 -17.0363 14.4799 -7263 6 26.0942 5.84138 12.9755 -8.81801 -1.79204 -2.94978 -7264 4 26.5644 5.00851 12.8396 1.48472 -6.22175 2.21387 -7265 4 25.1658 5.65249 12.7519 4.56693 -2.33816 -1.27821 -7266 6 9.00853 19.0479 23.7214 20.279 18.3012 -13.9253 -7267 4 8.07192 18.8993 23.8406 -12.3386 2.44029 -0.494901 -7268 4 9.09287 19.8709 23.17 -6.05991 -16.4473 11.9144 -7269 6 47.699 14.1778 40.0244 8.37408 5.46764 -8.11648 -7270 4 48.526 14.369 39.5365 -13.6583 -0.0280305 9.55934 -7271 4 47.2742 15.0291 40.2237 1.48315 -6.20176 -4.56159 -7272 6 47.9891 19.7944 0.501942 -52.5058 -34.5194 5.9677 -7273 4 48.5389 19.8149 1.25758 31.4646 9.24384 22.8657 -7274 4 47.3233 19.1101 0.79406 16.1078 24.936 -21.6052 -7275 6 27.1644 39.5895 31.4222 -35.4984 -42.2857 -13.2745 -7276 4 26.8828 40.2644 32.0188 2.45392 19.408 13.0965 -7277 4 26.334 39.0158 31.3353 32.2444 14.87 -2.1562 -7278 6 20.718 15.281 27.2921 -20.5288 29.0824 -25.1338 -7279 4 19.7916 15.5288 27.1303 0.0426049 -12.6319 11.5337 -7280 4 21.1251 16.0883 26.9354 13.4588 -8.377 2.43969 -7281 6 53.2931 3.12982 19.6939 21.059 35.3193 6.93312 -7282 4 52.5111 3.68486 19.642 -0.600406 9.66435 -1.15328 -7283 4 52.9649 2.26115 19.6482 -6.97037 -43.0252 -2.92507 -7284 6 40.7577 33.3874 24.037 12.7176 -1.25655 15.6318 -7285 4 41.575 33.1492 24.5319 -10.6485 3.51614 -11.0419 -7286 4 40.1417 32.64 24.1417 6.01104 2.31945 0.566227 -7287 6 50.2034 37.8915 21.3784 34.5696 42.4783 -9.46203 -7288 4 50.977 37.3667 21.5595 20.6596 -6.9612 4.63629 -7289 4 49.5128 37.3071 21.51 -51.1752 -39.6198 7.18684 -7290 6 41.3315 2.34663 21.9881 -5.34027 -0.787955 22.4754 -7291 4 41.3778 2.5308 21.0564 -4.51788 5.59338 -11.8441 -7292 4 40.4369 2.61524 22.307 16.348 -5.18373 -12.1741 -7293 6 3.68887 21.2797 14.3363 -13.7249 24.7693 -29.296 -7294 4 4.1389 21.9084 14.895 6.09004 12.6164 9.74183 -7295 4 3.85532 20.4521 14.7268 10.1618 -35.5887 19.7816 -7296 6 34.2749 11.1621 36.6211 6.86722 -26.3475 -8.98455 -7297 4 34.1457 10.3739 37.2084 1.76529 18.7936 -6.49638 -7298 4 34.0208 11.9523 37.0887 -10.0392 4.20616 19.2695 -7299 6 24.047 21.9251 23.4534 9.96695 -9.01801 9.45846 -7300 4 24.1056 21.4984 22.592 0.489969 -1.19981 -5.95122 -7301 4 24.6049 21.3417 24.0221 -10.3198 12.7259 -7.25629 -7302 6 18.8859 0.355593 4.41703 6.91373 -0.488994 13.8226 -7303 4 18.8848 41.346 4.15992 -3.4937 -3.21088 -8.69706 -7304 4 19.4141 0.350836 5.23016 -4.89519 7.76131 -7.17368 -7305 6 1.61894 7.82812 17.7388 11.0013 -2.20401 0.0755565 -7306 4 1.69825 6.91132 17.4299 0.598176 5.44338 0.144381 -7307 4 0.751076 7.92867 18.1276 -6.88769 -1.80246 0.772288 -7308 6 9.88357 31.5477 26.4865 20.7425 -47.9078 -25.9665 -7309 4 9.77347 30.8406 25.7562 4.13802 32.2768 29.9214 -7310 4 9.16637 32.1481 26.416 -28.5637 22.827 -5.6847 -7311 6 46.9801 33.0031 20.3665 8.92807 -2.6835 25.0439 -7312 4 47.1906 32.5959 21.2783 -12.5238 7.50902 -41.0074 -7313 4 46.473 32.3868 19.8049 3.08737 -2.68707 12.6131 -7314 6 49.5381 29.29 21.3848 5.35466 4.48298 6.61079 -7315 4 50.3596 28.8237 21.4263 11.6576 -22.6485 -14.6982 -7316 4 49.6544 29.7814 22.1942 -19.8316 15.0268 8.13943 -7317 6 13.5135 31.8933 19.1567 20.4477 19.0535 18.7588 -7318 4 12.9544 32.0303 19.9484 11.7182 -3.51681 -10.2564 -7319 4 14.3688 32.3555 19.4049 -26.6747 -15.4769 -10.5401 -7320 6 46.6242 34.0973 16.9259 3.25439 -22.1556 18.333 -7321 4 46.8986 34.1178 16.0034 3.18051 -0.659651 -5.23437 -7322 4 46.9878 33.2447 17.2966 -6.98741 23.2488 -14.973 -7323 6 19.7685 39.5238 2.42723 -1.93992 9.56528 -9.07466 -7324 4 20.504 40.1421 2.55739 -2.20075 -2.41675 -0.557551 -7325 4 19.2228 39.9982 1.75695 7.86662 -14.3322 13.7479 -7326 6 16.5372 9.39399 28.3106 5.81076 4.55242 0.698497 -7327 4 16.5228 10.3583 28.3138 -6.10914 3.2393 2.1867 -7328 4 17.4567 9.2086 28.1181 8.68803 -11.6531 -1.09187 -7329 6 3.04764 33.3834 8.9498 9.15555 8.47462 14.2626 -7330 4 2.34782 34.0603 8.86882 1.18173 -6.7492 -12.1187 -7331 4 3.16543 32.8691 8.13996 -9.91006 6.39371 -6.60301 -7332 6 49.6799 28.314 0.198287 -24.1009 9.02482 3.02524 -7333 4 50.5864 28.3416 41.8577 25.8797 -1.22492 -6.2647 -7334 4 49.539 27.5375 0.746128 -0.431885 -1.84115 5.43874 -7335 6 1.41501 6.84656 30.491 -4.80497 13.9866 22.936 -7336 4 1.80101 7.66454 30.873 3.64878 -10.2221 -13.1962 -7337 4 0.770406 6.61566 31.1883 9.6026 -0.286793 -13.8716 -7338 6 19.7721 9.41455 33.714 -8.86768 10.4812 -29.5452 -7339 4 19.9336 8.45599 33.7164 -2.74186 3.51224 -8.50186 -7340 4 19.4649 9.70036 32.7878 8.54711 -12.9815 34.2723 -7341 6 26.1689 11.9219 3.60877 17.3014 14.1658 -18.8808 -7342 4 25.6285 12.278 4.29668 -11.0155 5.7348 17.6305 -7343 4 26.0891 10.974 3.64129 -4.70103 -13.8965 4.54114 -7344 6 33.2526 2.15457 18.2061 -11.4346 36.8522 -3.73875 -7345 4 32.7853 2.99777 18.4754 10.6797 -23.9754 -11.6278 -7346 4 32.6748 1.45157 18.4903 -6.58847 -5.37306 4.71859 -7347 6 1.56641 29.1164 15.6218 -13.5802 38.9916 52.9136 -7348 4 0.75332 28.6899 15.9164 -2.28927 1.65734 -1.12046 -7349 4 1.88381 28.6368 14.9104 18.6776 -39.2188 -53.7174 -7350 6 41.7212 4.09992 39.5909 -11.2791 25.9615 -27.213 -7351 4 41.4168 4.81457 38.9155 6.653 -41.6332 33.8875 -7352 4 40.9635 3.53859 39.8438 1.60091 7.46224 -7.31473 -7353 6 28.6931 41.7984 21.1891 -6.68751 -8.42641 -4.80462 -7354 4 29.0735 0.780303 21.3271 9.25035 -16.558 -3.13259 -7355 4 29.3834 41.1221 21.0106 -2.7364 22.7931 4.70591 -7356 6 11.6395 12.4176 35.4525 -19.931 13.6599 -6.89173 -7357 4 11.6974 12.2316 36.3791 0.0383878 -4.43782 22.0781 -7358 4 12.5438 12.3774 35.1867 22.2579 1.64914 -11.6458 -7359 6 9.79005 12.0613 0.287125 39.0331 19.741 15.6941 -7360 4 10.6741 12.3652 0.649112 -24.288 -6.9143 -28.8601 -7361 4 9.37178 11.7496 1.07064 -16.9981 -12.0004 12.0483 -7362 6 48.1738 12.4001 9.21087 -14.7098 16.6281 -3.51107 -7363 4 48.3046 11.757 8.50338 5.36034 -5.93883 0.971929 -7364 4 48.886 12.3441 9.8545 11.7295 -7.72549 2.46367 -7365 6 20.1355 24.3829 18.9522 12.9308 -0.734849 -39.1055 -7366 4 19.4937 23.7815 18.5135 12.9255 8.80461 9.87411 -7367 4 20.8069 24.6162 18.234 -21.1698 -7.06963 26.7537 -7368 6 16.5393 31.2961 16.4761 -1.92172 -19.5246 -12.7122 -7369 4 16.66 32.2288 16.679 -4.64409 4.5232 17.4599 -7370 4 16.1207 30.7474 17.1716 1.36469 17.4989 2.94612 -7371 6 1.78169 14.6393 36.2977 19.9207 14.6923 -9.09136 -7372 4 1.03986 14.2937 35.8105 -15.9251 -7.35249 0.645581 -7373 4 1.68132 14.4688 37.2355 -8.64532 -4.94464 12.0587 -7374 6 4.36624 29.2084 29.5903 15.7403 17.1522 -11.4447 -7375 4 4.94475 28.7816 30.2313 0.42296 -3.8665 4.22363 -7376 4 4.9316 29.8996 29.1557 -19.5902 -17.4666 6.54186 -7377 6 43.6839 0.248111 22.6506 -19.7732 -13.3298 -9.50689 -7378 4 42.8764 0.661685 22.3065 0.028666 2.48852 1.60322 -7379 4 43.5183 41.2016 22.5042 11.2477 10.9397 1.57875 -7380 6 52.4994 40.9828 27.2386 -0.538127 -6.12089 -28.931 -7381 4 52.76 40.8447 26.286 -9.02638 3.90908 21.7421 -7382 4 53.2684 41.4137 27.6303 2.05735 4.02476 1.85103 -7383 6 25.5814 23.8969 27.7396 -24.7861 2.98762 0.531627 -7384 4 24.718 24.3642 27.6072 20.4038 -13.4527 4.15226 -7385 4 26.2821 24.4835 27.457 3.8963 1.45656 -1.88052 -7386 6 23.1228 17.031 33.3243 -5.52517 1.23961 5.4323 -7387 4 23.1399 17.5083 34.1558 0.441881 0.23205 -0.480567 -7388 4 22.8557 16.1383 33.5546 -4.67547 -8.64305 1.56256 -7389 6 2.92722 11.8725 21.3561 -41.4423 -19.1296 -19.7046 -7390 4 2.18606 11.2638 21.6443 29.5918 21.1066 -8.34803 -7391 4 3.54191 11.9259 22.0595 17.1072 -0.484489 21.5157 -7392 6 2.18317 4.15265 30.0257 5.779 -9.3787 -10.7468 -7393 4 2.12921 5.11001 30.0802 -2.76576 12.2821 -0.843831 -7394 4 2.67493 3.96573 29.2018 -3.29095 2.88479 4.98522 -7395 6 26.6728 30.2949 13.4768 7.17255 0.654769 14.1147 -7396 4 25.7117 30.2905 13.6467 8.22624 -2.44269 3.31295 -7397 4 27.1112 30.3188 14.3546 -11.9073 -0.623098 -17.8849 -7398 6 24.8734 30.8117 10.8292 -29.6944 -3.60301 -2.53615 -7399 4 25.2254 30.0431 10.3884 7.40196 -6.71761 -6.36825 -7400 4 25.5983 31.2424 11.2381 22.0508 11.6497 12.6203 -7401 6 53.1723 24.107 4.51212 -8.50651 -29.3458 16.902 -7402 4 53.5087 24.8189 4.00388 11.9327 21.9784 -14.7749 -7403 4 53.9335 23.6869 4.92936 2.49868 2.30602 2.88115 -7404 6 24.9006 4.49574 23.9943 -15.2803 12.8054 -1.91421 -7405 4 24.3197 5.26112 23.9044 -17.3839 -11.7779 6.16284 -7406 4 25.6928 4.95696 23.7819 42.3091 -2.82475 -3.31223 -7407 6 34.6808 1.64534 41.2582 -1.16689 -16.4189 -19.1193 -7408 4 35.6107 1.42238 41.0689 -7.35569 3.11738 8.02352 -7409 4 34.6894 2.06091 0.199506 5.11707 10.3461 19.9542 -7410 6 13.3318 19.5273 16.3875 10.456 -31.2285 9.008 -7411 4 13.8245 19.0713 15.6714 -4.89067 6.02882 4.66139 -7412 4 13.1633 18.7854 17.0362 1.8233 23.0525 -16.1268 -7413 6 48.6827 0.169575 20.4108 24.7259 -31.926 -14.6767 -7414 4 49.2893 41.6148 19.7702 -18.6338 21.3246 17.3218 -7415 4 48.933 41.6689 21.2514 -6.5025 5.85221 0.333279 -7416 6 43.0578 27.7881 11.5189 -10.6888 1.76469 -10.0665 -7417 4 42.6538 28.0077 10.6554 5.1393 -6.0393 10.108 -7418 4 43.5199 28.5835 11.7935 3.33621 0.984046 2.36511 -7419 6 25.7084 21.3766 35.1933 7.92601 18.71 -2.37973 -7420 4 25.8037 22.0957 34.5091 -5.30878 -22.9017 16.0752 -7421 4 25.4462 20.5484 34.7558 3.58761 11.0813 -0.636196 -7422 6 44.7325 4.60288 27.7529 -5.18995 0.47983 -9.95788 -7423 4 44.2388 4.02478 27.1463 1.34738 -4.40857 1.63455 -7424 4 44.3371 5.47709 27.6067 3.7052 -1.13476 4.16529 -7425 6 41.2786 11.441 34.2043 -0.416747 21.9122 -5.07112 -7426 4 40.7165 11.5703 33.4237 0.0697438 -4.14349 0.395824 -7427 4 41.2047 10.5155 34.4107 -4.51201 -19.8544 2.93408 -7428 6 19.8751 36.6454 2.03332 12.5662 31.6724 6.60432 -7429 4 20.6794 36.321 2.43856 -1.22315 -24.7147 -1.51883 -7430 4 20.0441 37.6041 2.15193 -20.0718 -8.75186 -9.57731 -7431 6 27.484 4.65653 6.35518 1.28922 -40.4385 -58.6648 -7432 4 27.5497 3.77116 6.72735 -1.75384 3.56143 11.9553 -7433 4 27.4257 5.33486 6.97498 -2.79123 31.4549 44.9969 -7434 6 16.8428 30.7659 39.9509 7.31092 -42.6244 -5.47757 -7435 4 16.9464 31.3097 40.7337 2.60533 1.47109 13.0941 -7436 4 17.1496 29.8303 40.1512 -5.48449 28.5555 1.20442 -7437 6 51.1542 15.2049 16.3406 35.1838 19.4064 -24.6303 -7438 4 51.2473 16.0791 15.87 -9.06363 -20.4986 13.944 -7439 4 52.0128 14.747 16.0894 -33.4595 8.32861 13.6861 -7440 6 49.9911 21.2271 35.9695 16.4294 -24.4585 13.2328 -7441 4 49.3547 21.5056 35.3276 -17.8928 6.13619 -17.6667 -7442 4 49.9245 20.2453 36.0087 2.29216 20.3869 -1.95357 -7443 6 34.4275 0.15221 5.68266 -0.837995 23.3079 0.855413 -7444 4 34.2957 0.929489 6.27037 2.93096 -11.6463 -16.4536 -7445 4 34.3488 0.459476 4.74482 0.623699 -7.30698 18.2278 -7446 6 48.316 11.5365 19.8846 -3.65813 -3.14803 11.8504 -7447 4 47.8503 11.3247 20.7373 6.31016 14.4835 -28.1035 -7448 4 47.7834 12.1052 19.2757 1.33379 -13.4076 20.6299 -7449 6 4.19577 39.4409 13.3607 25.3524 9.34899 10.5928 -7450 4 4.92582 39.74 13.9847 -33.0668 -7.48624 -17.3574 -7451 4 3.31127 39.5736 13.758 11.9971 1.78205 4.76714 -7452 6 8.7457 16.1809 8.53298 -1.62633 17.1572 -22.0575 -7453 4 8.74512 16.8853 9.19115 0.0519099 -7.3494 1.25428 -7454 4 8.72812 16.6658 7.66651 -0.023414 -16.7756 16.7144 -7455 6 29.0271 14.2712 26.5342 -13.8591 45.9397 20.1216 -7456 4 29.0757 15.2697 26.7309 6.93185 -43.1811 -12.6551 -7457 4 28.1042 14.0702 26.7795 9.9397 -3.04712 -3.53591 -7458 6 27.3813 14.5204 8.1419 -14.0666 1.8718 0.247246 -7459 4 26.4091 14.3966 8.10069 17.9482 5.30051 2.04476 -7460 4 27.5539 15.4689 8.31094 -4.76419 -14.5771 -1.3831 -7461 6 14.1301 27.2156 32.9232 24.3629 15.6041 -10.7258 -7462 4 14.926 27.3266 33.4685 -8.09546 -2.45296 -2.52419 -7463 4 13.4702 26.8045 33.4616 -14.5983 -10.6772 12.2116 -7464 6 31.6563 35.7792 21.2709 -29.1401 -25.1051 5.88501 -7465 4 32.0219 36.5153 21.7512 6.27263 14.1007 6.62418 -7466 4 30.8825 35.462 21.8184 22.9209 7.6802 -13.887 -7467 6 54.2186 28.7134 16.8958 -10.3287 11.0002 2.01575 -7468 4 53.5002 28.4234 16.309 3.24852 -2.61584 3.16662 -7469 4 53.9524 29.6107 17.1726 0.515277 -7.78004 -0.375364 -7470 6 9.0512 5.27483 17.1492 25.6572 1.38615 -17.9054 -7471 4 9.89534 5.12229 16.6101 -31.8522 3.085 22.1798 -7472 4 8.85255 6.23494 17.0921 1.81156 -15.0607 2.57474 -7473 6 29.6868 9.77258 26.5671 22.9889 -14.8503 10.4327 -7474 4 30.5444 9.2887 26.5838 -17.3341 11.3615 1.53321 -7475 4 29.3655 9.78642 27.4819 2.88877 -1.07091 -0.346791 -7476 6 44.0288 31.1766 32.1743 -14.2068 1.02328 22.4178 -7477 4 43.2475 30.9789 32.739 9.50682 -2.17476 -16.522 -7478 4 44.5788 31.7142 32.7564 8.88854 3.82935 -1.95952 -7479 6 53.49 3.62433 25.1454 11.2777 4.02107 -26.8953 -7480 4 54.1404 4.33507 25.1993 -2.49783 6.11479 15.045 -7481 4 53.6886 3.29227 24.2489 -10.294 -6.80459 12.4065 -7482 6 12.451 22.8746 3.38821 10.4278 8.96452 22.9237 -7483 4 12.7779 22.025 3.15024 17.1772 -24.972 1.67394 -7484 4 11.7815 22.9738 2.74712 -31.3784 16.165 -21.5343 -7485 6 39.42 29.6871 0.722943 17.2287 20.3893 -0.939439 -7486 4 39.938 29.1007 0.168548 -5.00448 -5.71086 -1.61555 -7487 4 38.6697 29.2119 1.03517 -14.5725 -11.7208 3.22357 -7488 6 13.7451 37.8179 23.0399 -3.65878 -32.3471 -6.65898 -7489 4 14.6418 38.0465 23.3627 -20.7195 15.519 -6.09735 -7490 4 13.1315 38.5597 22.9108 15.1185 11.2609 5.5967 -7491 6 33.3417 41.2334 -0.000336223 20.2285 27.8942 26.4667 -7492 4 33.8463 0.176253 41.7571 -17.5829 -26.3423 -4.93882 -7493 4 33.4991 41.0748 0.960438 -12.6248 -4.93214 -20.7453 -7494 6 15.7246 3.51737 6.33987 10.6879 -4.05507 31.4744 -7495 4 14.9251 3.29652 6.83809 -1.96505 1.65417 1.3128 -7496 4 15.4345 3.71468 5.4634 -8.944 6.24557 -22.4591 -7497 6 27.7713 30.7539 5.06912 -9.69485 -19.9648 -11.4393 -7498 4 28.5319 30.6575 5.66481 -7.77203 -4.90526 -3.90413 -7499 4 27.6074 29.8515 4.67882 9.36195 16.9347 11.4385 -7500 6 13.3277 7.57287 23.3467 18.1651 -5.37845 17.9429 -7501 4 14.1986 7.86136 23.0073 -11.0143 -2.49266 1.50668 -7502 4 12.7134 7.55433 22.6278 -8.93981 2.52131 -14.7715 -7503 6 38.3049 37.3174 27.9983 8.70135 -12.5747 15.655 -7504 4 38.3154 37.3922 27.0572 -6.74668 8.75695 -30.2201 -7505 4 39.0324 36.7087 28.1704 1.61648 -2.88985 11.5174 -7506 6 35.8266 12.5392 12.0897 -2.57405 -7.53067 12.8361 -7507 4 35.6491 11.5922 12.0112 2.97069 1.46586 -4.70523 -7508 4 36.2655 12.8127 11.2954 6.10525 2.83369 -11.8718 -7509 6 52.1153 23.0889 41.2774 53.3714 4.98692 -14.9993 -7510 4 52.5505 23.0114 40.3503 -31.9828 -2.74691 35.5054 -7511 4 51.1752 22.9201 41.2974 -16.3051 -5.99839 -13.4785 -7512 6 39.5458 11.6586 16.6081 -4.87816 2.10267 -34.9091 -7513 4 39.8889 10.7596 16.6462 4.61035 -3.54577 11.4771 -7514 4 39.4661 12.017 17.4857 2.58954 -3.33375 20.5696 -7515 6 0.680688 9.01153 7.97148 24.3969 36.1639 -33.0882 -7516 4 54.7452 9.01592 8.14854 -24.8099 -10.5681 8.91807 -7517 4 1.15172 8.32837 8.40327 2.66278 -26.2854 21.5078 -7518 6 42.3319 28.747 39.482 14.4944 54.9029 13.7373 -7519 4 41.6099 28.5069 40.0315 -24.977 -16.9351 14.372 -7520 4 42.5658 28.0062 38.9777 10.1954 -37.5926 -27.6332 -7521 6 38.7351 30.2774 16.2793 4.0737 2.19128 11.2593 -7522 4 38.8758 29.8829 17.1681 -0.562728 7.98522 -10.8415 -7523 4 39.3736 31.0181 16.2214 -9.64538 -12.7452 3.65311 -7524 6 7.59373 18.0328 0.655349 -39.2466 -13.429 1.02247 -7525 4 7.12412 17.545 1.38102 15.2508 10.2608 -15.5396 -7526 4 8.49503 18.0746 0.920891 28.7098 -1.69475 13.4339 -7527 6 33.7283 34.5883 24.1367 2.81913 -0.677006 -1.55035 -7528 4 33.5209 35.3543 23.5868 -0.36085 -2.23271 3.31185 -7529 4 34.0202 34.925 24.9956 3.1898 -0.550642 -1.12415 -7530 6 16.0108 40.0553 39.5926 -11.937 1.54577 -14.812 -7531 4 16.9471 40.1686 39.433 15.7688 -0.191962 4.71606 -7532 4 15.632 40.0274 38.6953 -1.55756 -1.47356 6.94311 -7533 6 4.49381 37.1265 21.8421 33.1234 -31.7004 -39.5319 -7534 4 4.78916 37.7556 22.4729 8.60512 21.3704 21.7375 -7535 4 5.32421 36.8863 21.3047 -36.9575 7.65083 16.8008 -7536 6 39.2568 20.1405 31.3294 -11.3601 -2.01094 -17.3558 -7537 4 39.2441 20.8952 31.9186 1.64276 10.2876 11.6417 -7538 4 38.6708 20.3662 30.5789 5.24327 3.39586 9.04201 -7539 6 28.5615 6.15748 32.0463 -1.77815 -13.6106 -5.56393 -7540 4 29.3688 6.39317 32.5024 4.03477 3.32162 5.90581 -7541 4 28.0645 6.97719 31.936 3.86184 3.53187 3.02469 -7542 6 9.32925 11.326 38.2021 -45.7357 8.82179 -18.9514 -7543 4 8.63026 12.0506 38.2047 26.1946 -20.5574 6.08922 -7544 4 8.95275 10.6938 37.5333 17.8336 11.1262 12.3014 -7545 6 41.6094 10.4714 6.86105 10.1449 -2.02989 30.4141 -7546 4 41.8033 10.1647 7.80154 -6.16714 11.7455 -31.3638 -7547 4 41.7667 11.4361 6.82819 -2.03628 -11.6206 -3.02795 -7548 6 3.11959 28.1093 17.6239 10.7497 -46.175 24.4008 -7549 4 2.68352 28.5892 16.9552 -19.7085 26.1099 -29.6067 -7550 4 3.57016 28.7359 18.1797 1.91623 14.188 4.79643 -7551 6 39.3448 12.237 19.2548 -14.1137 14.4353 18.1644 -7552 4 39.3198 13.2124 19.4672 -0.23776 -25.4214 -5.72266 -7553 4 38.5957 11.8144 19.7397 13.7352 7.639 -10.0067 -7554 6 2.76578 9.12322 31.711 10.2249 -26.7767 20.5709 -7555 4 3.2959 8.42892 32.18 -23.1647 11.967 -1.06293 -7556 4 3.41205 9.47362 31.1162 6.35119 16.2437 -14.7539 -7557 6 47.0978 34.3186 24.1743 26.4285 -20.6373 22.1669 -7558 4 47.9222 34.8155 23.9694 -26.3889 2.76484 -4.38573 -7559 4 46.3048 34.7125 23.8251 -6.69439 19.4391 -11.1209 -7560 6 41.2781 35.6191 9.5379 -9.82526 -0.200667 -5.59214 -7561 4 40.3156 35.6289 9.77314 20.3165 9.2235 -0.933793 -7562 4 41.677 36.5159 9.62264 -17.3348 -12.0484 0.717846 -7563 6 20.4662 31.4486 3.15039 -21.7086 3.64016 -5.07598 -7564 4 21.0332 31.2208 3.90109 -5.23001 0.711793 3.99895 -7565 4 19.5233 31.6154 3.43158 26.7394 -6.53789 -0.258783 -7566 6 33.2215 17.9623 24.8097 -0.453891 -1.34226 7.30289 -7567 4 34.1788 17.9667 25.0617 -18.0356 9.24084 -3.8919 -7568 4 32.8105 18.8566 24.8334 12.2893 -13.6267 3.75162 -7569 6 40.152 39.887 35.7648 -20.6867 7.32712 26.7748 -7570 4 39.5869 39.7633 34.9934 2.3303 1.35559 2.0998 -7571 4 39.5428 40.1203 36.5292 18.9615 -7.74514 -25.9591 -7572 6 4.86846 34.7127 16.4904 2.99496 1.45153 -7.51648 -7573 4 4.94748 35.6438 16.2302 0.473437 -5.16658 -0.520329 -7574 4 5.67201 34.2663 16.1683 2.12015 0.152524 1.06444 -7575 6 19.1332 11.0374 26.5471 0.604362 14.7011 2.3555 -7576 4 19.0986 10.7741 25.6217 -2.73437 -5.06461 -1.05922 -7577 4 19.4813 10.3027 27.0576 -1.53582 -10.5153 -0.687646 -7578 6 54.0201 13.9196 34.7874 -7.69802 -2.07317 -2.05829 -7579 4 53.0764 13.9769 34.9536 -3.33021 -5.1824 4.14914 -7580 4 54.0417 14.262 33.8952 13.8623 5.56658 -9.2157 -7581 6 1.84699 20.6587 5.20972 14.9439 0.361847 -39.2318 -7582 4 1.3018 19.9191 4.88605 -0.816153 4.45331 11.6833 -7583 4 2.38828 20.8916 4.39492 -13.6739 -1.13034 29.3331 -7584 6 22.2428 0.0912174 14.2544 2.10511 -1.36215 24.2926 -7585 4 21.4939 0.626329 14.4934 -11.4394 6.88953 -7.77601 -7586 4 22.6568 41.86 15.1175 2.53583 -3.69112 -10.285 -7587 6 4.95629 7.04242 24.7427 6.31781 -9.23371 -7.19194 -7588 4 4.17782 7.32111 24.2434 0.969413 4.1364 5.47863 -7589 4 5.24611 6.21648 24.3187 1.32276 5.05146 9.71893 -7590 6 41.4805 20.8726 34.9438 -11.2314 22.7349 11.4525 -7591 4 42.1022 20.1554 34.9949 12.4759 -11.6791 0.0999164 -7592 4 41.5325 21.3468 35.8092 3.20944 -13.6901 -15.0483 -7593 6 28.2157 1.74547 31.725 -9.95228 -2.94536 5.02618 -7594 4 27.5723 1.08944 32.0352 4.54694 0.234407 -12.282 -7595 4 28.3302 2.26918 32.5198 6.68924 9.49254 2.75715 -7596 6 16.8899 27.3746 36.9858 -9.49677 -4.03922 3.2671 -7597 4 17.2157 28.1459 36.4964 2.86939 -7.49192 -2.31982 -7598 4 17.0938 26.5386 36.5152 1.89463 15.2676 -1.69393 -7599 6 26.8243 38.069 8.34482 13.7761 41.6132 3.1747 -7600 4 26.4823 38.3279 9.22598 3.84792 -18.6223 -11.4711 -7601 4 26.785 37.1424 8.19579 -7.88027 -37.9853 9.71444 -7602 6 26.6634 33.7911 23.2273 -21.2745 -8.43567 7.74896 -7603 4 27.1019 33.3181 22.5212 7.04537 -0.372104 -6.32159 -7604 4 27.3305 34.169 23.7872 14.5385 6.50935 5.10733 -7605 6 10.2166 27.1183 30.2276 16.2509 -17.1331 -9.46175 -7606 4 10.1765 28.0583 30.3796 2.29392 15.9864 2.71565 -7607 4 10.9387 26.9511 29.5696 -14.5483 8.58048 15.0042 -7608 6 47.87 12.5975 5.02268 -6.13754 10.9902 -1.31963 -7609 4 48.1357 13.4822 5.34438 -4.36861 -17.8106 0.719643 -7610 4 48.2725 11.9144 5.56853 6.38614 1.6905 7.47062 -7611 6 53.3393 24.5639 22.1523 -40.2275 -1.43509 1.91788 -7612 4 53.1884 24.513 23.11 6.12251 -0.709171 0.80005 -7613 4 54.2538 24.6676 21.944 28.1496 2.10984 1.66559 -7614 6 29.4072 10.7569 19.3822 52.4151 15.8336 -9.71081 -7615 4 29.248 9.98119 18.8618 -10.0643 -15.3346 -6.0739 -7616 4 28.6282 10.9567 19.8417 -45.3483 4.87471 22.9978 -7617 6 39.4757 14.9522 19.5461 30.0359 -1.30311 42.0602 -7618 4 40.386 15.231 19.9108 -38.5728 -7.77311 -23.4682 -7619 4 39.3498 15.357 18.6983 1.75067 15.7407 -16.9704 -7620 6 32.8823 15.9838 22.806 -0.988113 9.61369 -4.64335 -7621 4 32.9657 16.5376 23.5815 3.43203 16.8704 5.79609 -7622 4 32.7087 15.1359 23.1895 -5.55033 -22.0541 3.57771 -7623 6 30.5481 1.96835 21.5144 8.4955 -1.31523 7.25762 -7624 4 30.7645 2.06729 22.4547 -1.5525 1.72807 -3.05596 -7625 4 31.3563 1.607 21.1075 -12.3766 3.94884 0.453046 -7626 6 0.972615 11.9937 3.31932 2.75381 16.0475 9.69945 -7627 4 1.12058 12.9582 3.29011 -6.67466 -9.20629 -8.78254 -7628 4 1.16803 11.7633 4.23669 1.49118 -7.35844 2.879 -7629 6 32.1487 30.4035 20.7885 -10.2937 2.79415 -8.64413 -7630 4 32.9584 30.6778 20.3377 1.19491 2.22071 -1.75985 -7631 4 31.4018 30.7106 20.2304 12.8433 -5.61998 7.3235 -7632 6 5.36663 35.5196 9.0005 -13.7636 -10.8617 -1.51226 -7633 4 5.10558 35.6694 8.09522 3.88385 7.21083 -8.97177 -7634 4 4.84313 34.7327 9.21079 3.19207 0.561776 9.20467 -7635 6 49.9075 13.051 32.2032 24.7068 -1.78611 -22.7634 -7636 4 50.5917 12.8604 31.4934 -20.1594 10.2365 23.451 -7637 4 49.3072 12.3042 32.1357 -5.12737 -3.80929 6.93874 -7638 6 4.31321 24.0956 1.58545 -15.4175 -15.0012 -21.2972 -7639 4 3.62325 24.7374 1.73273 -2.73087 12.0747 8.21305 -7640 4 3.96758 23.5799 0.823479 15.3265 9.07188 13.8923 -7641 6 44.1581 38.1227 12.3545 -1.42535 -29.4608 0.820402 -7642 4 43.4877 37.5183 12.7749 7.78878 22.0847 -6.23147 -7643 4 43.9706 39.05 12.5061 -8.83193 8.8938 6.46859 -7644 6 44.688 17.3349 22.7943 52.857 -4.21013 7.29678 -7645 4 45.2391 18.0521 23.242 -20.6522 -19.8992 -14.1432 -7646 4 45.3699 16.6167 22.57 -26.4285 25.231 9.0384 -7647 6 20.3608 11.6914 19.667 7.58964 -15.1508 -20.1027 -7648 4 20.0231 12.466 20.0832 -9.22037 21.7722 17.9466 -7649 4 20.541 12.011 18.7627 0.78957 -9.8802 4.31695 -7650 6 4.45783 15.4051 36.2022 4.17523 -10.6616 -1.13379 -7651 4 5.07913 14.7124 35.8925 -4.22209 9.46347 0.0108161 -7652 4 3.57023 15.0045 36.1544 3.18966 5.51307 1.04981 -7653 6 44.8105 39.5245 30.1712 -12.2097 -12.5983 -29.4865 -7654 4 44.6649 39.2374 29.2388 12.2423 8.81859 19.2473 -7655 4 44.0848 39.0946 30.6384 -0.298867 5.38951 7.86823 -7656 6 30.0635 3.50956 11.3278 16.0802 -2.39158 -40.3094 -7657 4 30.5444 4.30508 11.007 -11.8296 -5.04519 20.5985 -7658 4 30.1379 2.92562 10.5291 -8.6007 1.99314 24.6663 -7659 6 25.6288 24.8657 16.1423 35.3146 -5.68436 -0.158812 -7660 4 26.5897 24.7732 15.9989 -9.69879 -4.30362 -13.2764 -7661 4 25.6615 25.1054 17.0605 -14.6317 7.6504 23.2411 -7662 6 36.8074 29.8609 20.6529 -16.3286 -4.81766 17.6852 -7663 4 35.9316 30.2459 20.3982 14.0867 -8.19012 9.60149 -7664 4 36.7164 29.3161 21.4988 -1.56746 21.2483 -31.978 -7665 6 52.2273 17.0565 38.3075 -18.6216 -30.1938 15.1193 -7666 4 51.4912 16.4635 38.6201 23.7372 14.7716 -7.00173 -7667 4 51.7959 17.5937 37.6524 -0.777677 7.661 -6.77585 -7668 6 3.82637 23.6296 29.8591 26.0466 24.015 14.1033 -7669 4 4.67122 23.3872 29.4436 -4.98409 -4.75234 -2.50433 -7670 4 4.14214 24.3103 30.5173 -20.0237 -17.5461 -14.7603 -7671 6 6.36694 19.9104 41.0994 -7.87156 6.69529 -0.551213 -7672 4 6.75531 19.2216 41.6418 3.91706 -4.8357 7.00798 -7673 4 6.43687 20.7189 41.61 0.371167 5.3541 9.12827 -7674 6 28.9069 38.9219 35.3342 18.1363 5.4885 19.4373 -7675 4 28.4975 38.2544 34.8057 -13.0204 -17.6003 -18.1497 -7676 4 29.7244 38.4883 35.6529 -6.84193 6.3312 -4.3373 -7677 6 1.06391 30.294 34.4744 17.4659 -4.25802 33.126 -7678 4 0.923806 29.8092 33.6831 -4.92213 -16.9626 -31.6436 -7679 4 0.43107 31.0027 34.4841 -13.3738 11.5818 -2.38269 -7680 6 26.4433 22.0338 20.438 10.4135 -19.5508 3.73058 -7681 4 27.3849 22.2767 20.3653 -17.5193 8.20183 -1.91668 -7682 4 25.8117 22.75 20.2981 5.30742 7.62512 -2.77887 -7683 6 3.9439 18.647 22.686 19.6053 -30.212 14.064 -7684 4 4.76982 18.631 23.2404 -22.0254 9.00566 -12.7221 -7685 4 3.71052 19.5535 22.5456 -1.30938 28.7031 -1.82281 -7686 6 6.87955 39.3273 26.9921 -1.67667 -12.9446 -11.9216 -7687 4 7.1836 39.9129 27.6984 -12.429 3.42242 7.34442 -7688 4 5.90054 39.2886 26.9896 13.9064 15.8094 12.8698 -7689 6 43.976 41.7556 26.5281 4.8347 -4.89589 -5.39334 -7690 4 43.9038 0.242071 27.3891 4.48323 5.1383 20.2804 -7691 4 43.1144 41.9148 26.1591 -17.5097 2.26447 -13.804 -7692 6 31.7137 29.57 16.9845 -29.8695 1.84649 5.70955 -7693 4 31.0051 28.8814 16.8861 15.511 13.0746 -1.88966 -7694 4 31.2475 30.3377 17.3963 12.872 -19.7765 -2.8161 -7695 6 46.2467 10.9544 15.5549 14.6537 -15.0388 13.4913 -7696 4 45.2992 10.7621 15.4719 2.35584 -6.3837 2.44855 -7697 4 46.7422 10.1008 15.6673 -18.7057 18.8904 -8.1417 -7698 6 36.5806 15.025 25.8165 21.8026 1.76557 9.13915 -7699 4 37.3648 15.4873 26.2149 -21.7037 -15.0217 -10.3096 -7700 4 36.1201 14.6319 26.5704 -2.31195 -1.95921 2.19148 -7701 6 47.2758 22.6707 6.12549 -20.393 21.5378 -17.5673 -7702 4 46.5536 23.2672 5.80637 16.9751 -15.6011 5.88158 -7703 4 47.0174 22.4855 7.02503 2.56882 -3.04752 8.65489 -7704 6 27.5281 39.6653 17.8063 9.11062 13.5998 -14.667 -7705 4 26.6008 39.6971 17.5421 -9.18871 -3.65478 0.40423 -7706 4 27.5952 39.1072 18.5692 -4.91094 -8.97362 13.813 -7707 6 14.0432 27.9674 36.8911 6.42031 -13.692 3.20322 -7708 4 13.4093 27.2386 36.6831 22.3711 16.0651 -1.21324 -7709 4 14.9745 27.6178 36.9209 -23.5128 3.35359 -2.56993 -7710 6 33.7582 13.0225 13.8549 2.82411 10.3644 -10.1378 -7711 4 34.6192 13.1187 13.3682 -26.1927 -14.0119 11.7219 -7712 4 33.447 12.1034 13.9061 16.5995 3.21583 -3.74575 -7713 6 3.39066 17.4794 1.96807 -11.027 -24.2448 -29.9928 -7714 4 3.01559 16.7425 1.36999 17.4474 35.7284 24.3857 -7715 4 3.43148 18.2603 1.39088 -0.910914 -5.0095 5.82543 -7716 6 27.5636 2.76805 36.4448 23.3016 6.40537 7.49337 -7717 4 28.0874 2.94382 35.6362 -14.0128 -4.70143 5.95918 -7718 4 26.7201 2.39292 36.1778 -1.1877 -0.145823 -5.22631 -7719 6 21.3174 1.20043 18.721 3.60184 -34.5623 26.1973 -7720 4 20.9731 2.06802 18.64 -8.90193 33.3239 -10.7294 -7721 4 20.989 0.903829 19.6038 6.52339 -1.5964 -17.0558 -7722 6 11.8953 16.678 29.2972 -24.0209 -12.1876 15.7906 -7723 4 10.9907 16.5502 28.9196 20.2967 4.53139 4.03679 -7724 4 11.83 16.2797 30.2084 5.50538 14.3948 -24.2902 -7725 6 15.9723 29.4609 29.6333 0.682268 26.1612 18.9471 -7726 4 16.8848 29.3174 29.3467 -1.47573 8.2327 2.84191 -7727 4 15.9822 30.2485 30.2615 3.64459 -27.0302 -18.4378 -7728 6 42.9269 7.03734 4.5197 11.663 -6.03152 6.53833 -7729 4 43.4231 7.50219 3.8104 -1.91258 -11.2042 14.7177 -7730 4 43.564 6.5391 5.10838 -14.9069 13.4822 -19.2581 -7731 6 46.4099 26.3175 18.5001 -14.65 2.77244 -10.2078 -7732 4 46.6739 27.1133 19.0164 -10.4759 -17.1195 -12.5948 -7733 4 45.7242 26.5969 17.8403 16.3643 -1.95791 15.5671 -7734 6 26.8576 31.9381 30.1176 11.4414 -26.9795 -35.8502 -7735 4 27.1259 30.9869 29.8859 -9.79711 36.6724 15.314 -7736 4 26.5998 32.3006 29.2227 5.46388 -10.7605 29.9307 -7737 6 19.4818 37.6192 31.2596 -32.5143 -22.3469 33.0613 -7738 4 19.0962 36.8501 30.8088 8.72557 8.52431 -5.84089 -7739 4 19.0944 37.5229 32.1795 16.9146 13.3756 -22.466 -7740 6 52.3665 32.7318 12.7942 -5.34222 7.33615 -3.08781 -7741 4 51.884 32.8768 11.9489 17.9119 0.95058 7.1847 -7742 4 53.27 33.1068 12.8183 -18.0778 -3.45769 -11.3622 -7743 6 6.73992 9.26339 24.0285 -18.4022 -33.2824 -0.456279 -7744 4 6.43016 9.52976 23.1488 2.39009 0.543925 -1.37305 -7745 4 6.14044 8.50785 24.2751 15.0572 15.2043 -3.93749 -7746 6 39.7373 39.5658 25.499 -11.0807 -5.52867 0.517577 -7747 4 39.7453 38.628 25.2585 2.77876 5.57729 -0.31401 -7748 4 38.826 39.699 25.8216 4.65786 0.889055 -1.26295 -7749 6 24.0734 14.0105 21.1438 13.9648 5.3121 -25.5312 -7750 4 23.6065 13.6215 21.8839 -3.42696 -11.6299 6.48748 -7751 4 24.3304 13.3134 20.491 -9.48085 14.6929 20.6508 -7752 6 5.1987 41.7736 24.8713 10.0047 -19.0707 10.1325 -7753 4 6.05769 0.0475547 25.2635 0.547146 -1.74599 -5.91735 -7754 4 4.86042 0.69526 24.5593 -4.41349 12.4443 -5.8689 -7755 6 42.3687 20.86 21.2777 19.2234 -22.1312 -1.40502 -7756 4 42.3783 20.5581 22.1846 0.624409 -1.73106 8.2154 -7757 4 41.7113 21.532 21.2665 -20.5735 20.428 -5.9858 -7758 6 48.2425 15.3687 33.5924 -0.241089 -2.38933 -5.28694 -7759 4 48.6415 14.7162 33.0072 6.18243 -4.87195 3.86709 -7760 4 47.6596 15.8553 33.0028 -7.11438 7.34599 -0.780278 -7761 6 46.0202 38.2953 16.5865 15.7829 17.4793 7.01852 -7762 4 46.7193 37.7552 17.0318 -13.8218 15.7663 -8.05182 -7763 4 46.1673 39.253 16.8241 -2.73609 -24.364 -6.22008 -7764 6 4.62701 28.4898 21.3631 -35.4199 -38.8764 -1.71187 -7765 4 5.05003 28.7578 22.1614 14.3175 13.903 20.3467 -7766 4 4.23296 27.6059 21.6238 11.0236 23.568 -16.8729 -7767 6 20.5692 15.1618 18.3974 -2.72234 -3.16682 18.7699 -7768 4 20.0205 15.9086 18.1633 -0.374776 9.93651 -8.10169 -7769 4 20.1114 14.8073 19.1799 7.71486 -3.14336 -3.02048 -7770 6 16.2446 13.6415 17.4737 -35.4034 4.06645 -23.9936 -7771 4 16.1835 14.6144 17.5029 6.20848 -12.1 -0.082548 -7772 4 15.5556 13.4035 16.7727 24.4056 2.85778 27.0666 -7773 6 52.5084 30.9566 18.1567 -0.97573 -12.5044 17.346 -7774 4 52.0533 31.4717 17.4985 -6.50351 10.4198 -16.9401 -7775 4 51.7821 30.6074 18.6971 11.4062 2.54252 -4.46582 -7776 6 24.418 1.73203 15.7939 2.07222 -10.1482 7.47229 -7777 4 24.2447 1.14878 16.5739 0.390494 16.7143 -9.44633 -7778 4 24.1366 2.64887 15.952 -0.929678 -6.23215 5.34629 -7779 6 23.8719 5.08832 31.0744 22.7283 -21.9769 -16.2257 -7780 4 23.8146 5.92648 31.5054 -7.3092 22.9653 9.22328 -7781 4 24.8319 4.92382 30.9303 -16.6577 0.531409 1.66203 -7782 6 29.6615 30.9343 0.410524 16.5859 -5.2272 -6.83283 -7783 4 30.4171 30.5602 -0.0763344 -8.98044 0.909776 12.9407 -7784 4 29.1293 31.2514 41.5907 -13.3941 8.54792 -1.14443 -7785 6 32.8591 37.9003 22.5268 -10.9299 -3.56267 -2.34485 -7786 4 33.7082 38.1164 22.1304 5.81458 1.66065 7.83892 -7787 4 32.835 38.1832 23.4516 6.53001 6.08896 0.386172 -7788 6 16.4762 17.3653 33.758 -11.7596 5.685 -6.41316 -7789 4 15.9639 18.0545 33.2621 15.6067 -10.6469 10.7903 -7790 4 17.1589 17.009 33.1621 -6.01342 7.59956 -1.04496 -7791 6 9.22918 13.3839 27.5418 -13.213 -9.30661 16.5651 -7792 4 8.30942 13.5198 27.2923 -4.71042 4.84624 -13.6557 -7793 4 9.0972 13.1179 28.4658 14.0632 -0.809421 3.61995 -7794 6 43.4685 7.73978 17.2176 -8.6426 5.21856 8.44668 -7795 4 43.4054 7.77113 18.1985 3.14312 -1.73226 -22.4674 -7796 4 44.4071 7.82788 17.0033 -0.931382 -0.0897333 1.197 -7797 6 22.3132 24.3412 23.1703 -9.75348 13.1727 -0.0757149 -7798 4 22.7871 23.5122 23.2675 1.8966 -9.89464 -1.11237 -7799 4 21.5045 24.1854 22.6454 4.5924 -1.52242 4.18414 -7800 6 26.0037 32.9236 32.716 -4.33416 -0.788049 -7.61174 -7801 4 26.2455 32.6516 31.8136 -0.0498336 0.850388 -0.133699 -7802 4 25.1949 32.4304 32.9126 -0.360701 -0.787143 2.76329 -7803 6 16.9426 19.041 7.45715 -3.10994 24.472 -2.41526 -7804 4 16.308 19.3093 8.14456 3.13816 -6.91205 -2.30089 -7805 4 17.0114 19.8381 6.87129 1.57938 -24.3813 10.2947 -7806 6 48.1131 14.4569 27.5699 7.08917 8.35207 6.49885 -7807 4 48.0603 15.1245 26.8691 -1.5138 -4.18476 1.16992 -7808 4 48.1537 14.9494 28.4126 -1.96213 -3.76556 -9.73571 -7809 6 52.3834 41.7541 11.1123 -0.447482 12.3 22.2377 -7810 4 52.3153 0.228199 10.2442 -0.817032 7.00513 -16.5207 -7811 4 52.6623 0.571857 11.7011 -4.41087 -5.87968 -8.23494 -7812 6 36.3325 6.93202 12.7048 -8.66608 5.7588 -1.53482 -7813 4 36.3873 7.88419 12.9074 5.41886 -9.49824 0.0534512 -7814 4 37.2464 6.6206 12.6662 3.93968 -0.5832 -0.272047 -7815 6 8.24609 20.3242 16.6676 2.28714 -8.73249 -3.11806 -7816 4 7.99607 19.3797 16.5602 0.915774 9.85224 4.30221 -7817 4 9.21956 20.3717 16.6442 -3.81833 -2.78155 -1.09608 -7818 6 28.8059 40.3215 12.8316 -6.32157 -2.99739 9.80695 -7819 4 29.5356 40.2333 12.2314 15.0973 -2.52646 -11.1155 -7820 4 28.4555 39.4209 12.8947 -4.4969 5.39171 3.74805 -7821 6 18.1648 11.8204 16.9538 6.42365 10.4423 10.6103 -7822 4 17.6537 12.6149 17.1793 -7.21931 -10.1359 -1.31065 -7823 4 19.063 12.1656 16.925 9.05203 -3.86377 -1.18548 -7824 6 30.8803 17.4233 21.4874 -38.9186 -21.5127 -11.6054 -7825 4 30.1793 16.7188 21.4067 15.4039 25.3522 4.50617 -7826 4 31.5864 16.9116 21.8642 20.5617 -1.86838 10.7411 -7827 6 34.8073 19.4112 37.959 10.4013 19.2527 -16.7989 -7828 4 34.9062 20.1671 37.3279 -0.177011 -16.5385 16.965 -7829 4 34.2544 18.768 37.5084 -3.31564 -7.45818 -3.12702 -7830 6 35.8251 16.8879 29.2053 19.9429 8.12055 25.1888 -7831 4 36.604 16.4922 29.6427 -6.21008 5.15879 -2.88988 -7832 4 35.5164 16.1914 28.6524 -12.7517 -21.289 -18.0185 -7833 6 3.03682 32.2806 6.33235 -9.22618 28.6071 10.2197 -7834 4 2.10307 32.1357 6.11945 6.4331 -12.4482 -1.5948 -7835 4 3.56193 31.5065 6.1559 2.8275 -21.5224 -7.32445 -7836 6 26.8 41.6522 10.1614 16.4152 -10.6242 6.62789 -7837 4 27.6763 41.4103 9.75871 -19.2491 6.11251 13.5217 -7838 4 26.9685 0.0827479 11.0562 4.26354 0.263175 -7.76775 -7839 6 52.2755 24.564 24.8743 -17.4742 4.09161 11.4913 -7840 4 51.3068 24.6875 24.9545 12.6777 -6.48001 -7.54331 -7841 4 52.5704 24.9086 25.7267 7.88636 1.59704 3.61539 -7842 6 22.6859 22.6471 33.5865 3.00815 -0.389016 -3.70522 -7843 4 23.2377 23.2516 34.129 -18.2936 -9.34398 -1.8364 -7844 4 21.8798 22.3666 34.0572 9.18357 8.33181 5.74035 -7845 6 10.6559 14.2334 33.0439 8.40108 -6.88321 -2.71679 -7846 4 10.5166 14.9368 32.4181 8.42324 10.9453 -12.1325 -7847 4 9.76709 14.0756 33.3137 -17.8131 -11.8211 11.2552 -7848 6 21.913 10.8504 11.5417 10.0273 5.1408 -10.1307 -7849 4 22.8643 10.6911 11.6864 -4.5907 0.219491 7.97275 -7850 4 21.4519 10.7503 12.3817 3.5408 -3.26695 13.1151 -7851 6 38.3604 6.02409 25.8423 -7.72295 28.2176 13.9057 -7852 4 38.0159 6.28095 26.7202 2.23326 -16.155 -4.56644 -7853 4 38.4362 6.90267 25.4438 5.48615 -7.56939 -11.5178 -7854 6 30.9465 26.6393 38.5732 9.04128 -30.5088 -25.1958 -7855 4 30.9128 26.4505 39.498 -1.67119 3.99535 28.8865 -7856 4 31.0441 25.726 38.2186 -4.36445 16.9712 0.749916 -7857 6 30.1667 14.6301 35.4838 10.1392 5.1159 -4.4805 -7858 4 30.5216 15.3681 34.9096 -25.1579 -14.4294 10.0398 -7859 4 29.1929 14.5877 35.5299 11.6839 11.6021 -8.75286 -7860 6 12.5351 37.2243 16.9695 -17.9994 -5.54058 0.759354 -7861 4 12.9667 37.9067 17.4519 9.84296 27.0859 15.3185 -7862 4 13.2146 36.5653 16.9126 10.1753 -19.489 -6.1469 -7863 6 27.4306 21.5582 37.7184 0.323044 -0.91237 -2.80926 -7864 4 26.8919 21.7087 36.9418 -1.95891 -4.49412 -14.6911 -7865 4 26.9535 22.0297 38.3943 0.198826 4.23191 11.3586 -7866 6 29.6082 18.3788 12.6829 -3.7237 -11.7076 25.6006 -7867 4 29.4829 18.1024 13.618 2.9495 3.49705 -16.1413 -7868 4 28.7034 18.5321 12.3984 -4.77545 3.00323 -3.28229 -7869 6 2.3585 15.6468 0.175999 -8.20612 37.5639 57.3692 -7870 4 1.52386 15.5898 41.6501 -20.1916 -9.73007 -21.8008 -7871 4 3.00191 15.1099 41.6903 28.5072 -35.3577 -30.6151 -7872 6 17.8194 25.7234 4.22068 -18.7286 -4.35761 2.03057 -7873 4 16.8619 25.5897 3.93795 36.6055 5.10926 -2.3659 -7874 4 18.4291 25.8425 3.4621 -13.2431 -0.0346718 7.72723 -7875 6 41.7912 11.1794 20.2704 -4.7703 -4.22644 -3.97484 -7876 4 42.5222 11.2179 19.6258 -6.77094 -1.14571 2.2342 -7877 4 40.9861 11.4636 19.8126 1.73275 2.14556 -1.92771 -7878 6 38.0378 18.3863 24.0278 -3.74133 -10.331 -0.132081 -7879 4 38.4309 19.0888 24.5482 3.22643 8.24914 5.57345 -7880 4 37.9308 18.7305 23.1431 0.767244 4.53126 -6.25669 -7881 6 4.13298 13.9173 33.7521 30.6843 -35.3272 -10.2657 -7882 4 3.2388 13.7394 34.0326 -6.45696 -6.01886 0.999898 -7883 4 4.62487 13.0231 33.6052 -30.6419 39.0128 7.66426 -7884 6 19.1936 19.1847 26.5022 -1.72621 -3.50471 2.07629 -7885 4 19.5259 20.0399 26.2155 5.41694 7.89262 1.74938 -7886 4 18.9505 18.7515 25.6854 -0.500338 -7.01675 -4.74744 -7887 6 22.475 26.1945 25.3345 -21.4458 -23.9003 -3.16659 -7888 4 22.3709 25.4906 24.6814 -7.32491 -4.57374 0.352876 -7889 4 23.3013 26.5414 25.0733 33.537 19.6696 -4.44151 -7890 6 48.8098 32.073 32.5556 -12.1052 4.48194 -0.190297 -7891 4 48.9381 31.1381 32.4233 -5.03309 -16.3747 0.495313 -7892 4 49.6354 32.4434 32.2762 12.9514 12.9364 -2.07298 -7893 6 25.2177 18.014 27.013 4.13139 4.11129 3.02633 -7894 4 24.4991 17.5573 27.49 6.6231 -0.568789 -7.074 -7895 4 25.6482 17.4406 26.3525 -8.92874 -1.57445 7.95973 -7896 6 1.76475 41.5608 24.9549 2.89162 -9.06076 -21.1384 -7897 4 1.88611 40.794 24.3317 -1.07403 19.5272 24.3581 -7898 4 1.30092 0.287142 24.3881 5.67761 -7.93757 11.1942 -7899 6 18.6633 11.7702 10.8608 -14.1102 -15.1967 11.3789 -7900 4 19.5021 11.9001 10.4051 -2.67857 -1.17934 -0.0567829 -7901 4 18.6465 10.841 11.1975 0.382459 20.6246 -9.54243 -7902 6 45.6242 16.5573 4.85031 17.0541 -2.39304 -3.72853 -7903 4 46.5701 16.2411 4.85652 -23.9929 13.0597 -1.64852 -7904 4 45.6057 17.5078 4.58964 5.38323 -15.7737 4.77093 -7905 6 40.6798 36.3894 24.0177 5.99482 15.2006 -18.5281 -7906 4 40.7505 36.8152 23.1136 -3.68852 -16.1642 25.9152 -7907 4 40.7388 35.4259 23.9735 0.360603 0.79119 -4.57544 -7908 6 32.2161 36.322 4.9431 5.19197 18.2152 11.0878 -7909 4 31.5074 36.1415 4.30154 10.9387 -10.0795 -6.57323 -7910 4 33.0257 35.7839 4.88769 -13.0089 -6.05715 -7.93038 -7911 6 1.60369 14.6754 10.8168 -10.3056 7.30247 33.6992 -7912 4 2.33423 15.3134 10.9307 -7.1595 -6.86026 -1.25923 -7913 4 1.1476 14.6845 11.711 13.0511 -0.847163 -26.6328 -7914 6 35.0153 14.2871 28.0739 18.7596 2.69464 30.5166 -7915 4 34.8734 14.0618 29.0187 14.279 3.49385 -12.2543 -7916 4 34.1456 14.1907 27.7398 -26.4062 -1.19123 -20.5956 -7917 6 54.7157 6.11907 21.8609 -12.1949 -7.16094 1.89291 -7918 4 53.7846 6.03827 22.1577 10.7478 1.95047 -3.13077 -7919 4 0.0370646 6.90146 22.3147 2.89466 7.98076 3.79048 -7920 6 31.7642 16.9274 27.3665 -7.54316 -5.52924 6.90942 -7921 4 30.8348 17.1206 27.2023 -9.34166 0.83246 -0.0222557 -7922 4 32.1928 17.2544 26.5838 13.9998 7.82105 -16.2222 -7923 6 14.4504 28.0052 11.1087 -4.71237 -14.6735 4.6077 -7924 4 14.1081 28.8557 11.3451 -9.65694 14.7183 8.34222 -7925 4 14.826 28.1745 10.2406 5.25389 -7.26775 -5.19981 -7926 6 35.6627 19.4906 18.309 1.38743 3.66357 1.00844 -7927 4 36.0608 19.4502 19.1905 -8.3289 1.62604 -1.04031 -7928 4 34.971 18.8114 18.299 7.41978 2.58016 -0.85803 -7929 6 0.908295 12.7232 15.4509 -10.2874 -45.1283 5.64528 -7930 4 0.635795 11.7526 15.3361 10.0925 35.0181 2.47128 -7931 4 1.39513 12.719 16.2997 -3.76012 1.73199 -7.91518 -7932 6 52.7239 14.8052 20.9911 -10.1838 -50.8962 13.8805 -7933 4 52.1355 13.9729 20.9263 20.4043 37.1153 -0.0771148 -7934 4 52.3678 15.481 20.4204 -9.75671 2.85516 -9.21068 -7935 6 7.50014 6.78453 13.6112 45.6118 -3.77462 -0.237279 -7936 4 7.66407 7.72531 13.7166 -11.095 5.64184 -2.33744 -7937 4 8.44113 6.46934 13.5548 -33.3093 -4.56257 -1.46213 -7938 6 12.8693 29.1327 30.951 -35.1999 43.7452 -37.9705 -7939 4 12.911 28.5157 30.2274 6.73286 -14.9776 0.757022 -7940 4 13.2432 28.8129 31.7306 26.8069 -31.1286 39.1504 -7941 6 8.91269 29.9946 35.6682 4.82638 -20.5676 13.9142 -7942 4 9.08199 29.9869 36.6487 -3.4848 12.9743 -23.6701 -7943 4 8.85763 30.8835 35.2999 2.4913 8.97671 5.8399 -7944 6 29.2501 7.21193 5.56384 -35.3124 23.3999 -5.45769 -7945 4 29.8929 6.567 5.7677 24.3163 -25.3556 4.38867 -7946 4 28.4878 7.00912 6.14468 16.2636 8.35776 -7.44031 -7947 6 25.8882 9.2493 3.85609 -10.1418 -10.3657 2.14015 -7948 4 26.6938 8.77544 3.58522 -5.62061 -1.52714 -0.987441 -7949 4 25.143 8.71761 3.5088 14.4855 4.13341 2.07026 -7950 6 46.1828 19.5303 23.8452 27.5142 -8.79556 18.2338 -7951 4 47.0303 19.3932 24.4147 -29.6641 11.3761 -34.952 -7952 4 46.4302 19.9015 22.9687 10.0609 -5.49214 13.8961 -7953 6 18.6 35.3226 28.7813 33.9262 -21.2248 5.29661 -7954 4 18.5078 36.1255 28.2543 2.15121 5.76995 -5.3877 -7955 4 19.5645 35.0126 28.755 -37.0827 17.274 -2.06568 -7956 6 28.0068 22.625 32.1882 17.1638 -9.71048 -11.652 -7957 4 28.1161 23.0799 31.3381 -0.933036 0.686599 6.01892 -7958 4 27.1717 22.9224 32.5558 0.319614 0.839726 2.26602 -7959 6 25.9992 18.4251 22.6716 -8.51512 -6.6596 14.3523 -7960 4 26.8098 18.8237 22.3895 20.3106 6.57833 -11.9809 -7961 4 25.8253 18.8771 23.5162 -1.041 -7.57666 -6.79729 -7962 6 31.1689 23.0872 29.1831 -2.26749 -18.4759 6.78914 -7963 4 31.118 22.1592 28.8841 -5.05583 5.59361 3.05947 -7964 4 31.7418 23.5345 28.5581 5.1573 7.79625 -4.49352 -7965 6 36.6391 4.9259 0.480345 37.9344 10.2065 -26.5572 -7966 4 36.638 5.82198 0.886244 0.658013 -14.6584 -5.92388 -7967 4 37.39 4.95173 41.699 -35.1456 1.42767 30.4358 -7968 6 36.484 21.0145 10.0529 -6.00883 6.48187 8.17175 -7969 4 36.4042 20.1763 9.58301 3.63574 2.58382 -3.15576 -7970 4 35.8773 20.9259 10.8015 2.14778 4.06152 -0.936887 -7971 6 50.5993 25.1947 18.3919 -28.2028 12.9956 8.35013 -7972 4 49.869 24.7394 17.9262 9.19638 1.46827 3.55355 -7973 4 51.4482 24.8993 18.0848 11.0575 -8.08323 -5.33222 -7974 6 50.1824 39.6576 12.4356 -22.7811 -7.9912 15.1349 -7975 4 49.7705 38.7879 12.6194 4.75387 11.043 -2.88475 -7976 4 51.0686 39.4751 12.1603 15.8621 -1.53988 -6.37666 -7977 6 30.5412 12.4178 4.80566 -15.3128 -2.78075 25.3711 -7978 4 30.0752 11.5776 5.01806 10.6669 11.6172 -5.90727 -7979 4 31.021 12.2424 4.01172 11.531 -8.83371 -18.4272 -7980 6 28.9525 15.4713 21.8679 -2.36978 -36.4192 26.6063 -7981 4 29.1677 14.6271 22.3934 -7.66269 33.2693 -19.6276 -7982 4 28.1632 15.8063 22.3348 7.54721 -2.84859 -11.2752 -7983 6 14.0684 9.5583 16.997 2.7235 -6.59901 -0.744295 -7984 4 14.8185 8.94582 17.0717 -0.0957791 5.7783 -3.11218 -7985 4 14.4323 10.4488 16.9992 1.00571 2.57913 -1.39277 -7986 6 4.48903 30.1743 11.858 18.777 -10.7052 13.2768 -7987 4 4.86699 29.7697 12.6847 -17.3276 7.96894 -17.1216 -7988 4 3.53137 30.2861 11.9207 -0.113543 -0.314347 4.01346 -7989 6 40.8874 8.0652 23.6541 0.993335 -18.0149 -24.6412 -7990 4 41.0014 8.23968 22.6934 -0.45004 7.6784 15.1082 -7991 4 40.7726 7.0925 23.6399 1.20374 9.92563 8.58777 -7992 6 53.7462 35.0557 16.7061 9.98011 -4.48961 -22.2856 -7993 4 53.4827 35.8182 17.2307 0.000554802 6.10184 -1.96461 -7994 4 54.0786 35.3449 15.8213 -7.68991 -0.599931 23.4559 -7995 6 53.7073 10.1889 20.3718 -10.7517 16.2467 -19.4493 -7996 4 53.8408 10.0262 19.4272 8.41512 -10.415 5.03553 -7997 4 53.1338 10.9644 20.2967 0.731263 1.06205 11.7435 -7998 6 4.58979 27.075 7.78807 17.6653 -15.6715 -1.75621 -7999 4 5.19096 26.32 7.80399 16.3727 7.79792 -3.24405 -8000 4 3.78382 26.6199 7.94519 -28.415 1.42755 3.38346 -8001 6 50.5066 22.5306 22.1436 -1.2339 18.6921 5.41009 -8002 4 50.2802 23.3104 22.6632 -2.8343 -11.09 7.6214 -8003 4 50.7991 22.9414 21.3369 4.56213 -7.53044 -15.8119 -8004 6 7.04346 27.196 21.628 9.41144 -9.96736 11.8657 -8005 4 6.8407 26.6883 22.4668 -8.25713 16.2835 -27.3312 -8006 4 6.26031 27.4748 21.116 4.26862 -9.43237 15.0117 -8007 6 23.8265 35.0499 16.5937 18.3012 9.13896 26.4348 -8008 4 24.7235 34.8381 16.9269 -14.9485 7.62278 -2.13189 -8009 4 23.7604 34.5968 15.7714 -3.77201 -11.7597 -22.7393 -8010 6 5.98953 23.8983 3.91761 -44.4181 -14.5448 -1.98234 -8011 4 5.398 23.9519 3.1318 15.794 0.401012 8.45254 -8012 4 5.35617 23.6012 4.61938 19.6174 4.72778 -5.04958 -8013 6 38.7401 25.0729 19.1247 8.8169 4.91643 10.7802 -8014 4 38.7862 24.2921 18.5681 -1.99613 -8.272 -9.94687 -8015 4 39.0639 24.8191 20.0061 -2.94522 4.87881 -4.09917 -8016 6 12.9717 18.2893 10.6182 7.92512 -8.05782 -7.58833 -8017 4 12.0999 18.3162 10.2013 -2.76008 2.25331 1.21984 -8018 4 12.8722 18.6085 11.5165 -3.68712 5.29275 10.5515 -8019 6 38.0382 41.2423 21.0873 4.88219 -19.6272 -0.152698 -8020 4 37.2014 40.7765 21.2484 2.63704 8.02432 -2.02816 -8021 4 37.8835 0.198079 20.7163 -11.2369 15.8096 -5.69312 -8022 6 6.98214 22.8682 17.8394 -5.75247 -17.9204 -1.57462 -8023 4 7.61723 23.542 17.6412 15.6839 20.0065 -5.16874 -8024 4 7.3587 22.0484 17.4826 -2.13646 0.815835 3.23256 -8025 6 24.1186 19.368 12.3177 21.0449 6.23804 -24.2445 -8026 4 23.9242 19.844 13.1293 -4.19124 -3.15082 3.8784 -8027 4 23.743 18.4928 12.3308 -10.9397 -14.908 7.07664 -8028 6 44.2213 28.4415 4.8153 2.12167 -7.44997 -5.8313 -8029 4 44.3009 28.0649 3.91739 -1.37383 9.18016 5.99771 -8030 4 44.2294 29.4128 4.74855 1.01191 -3.53144 -7.03239 -8031 6 23.3167 8.29314 21.4338 -0.329791 14.7993 14.6131 -8032 4 22.995 9.23581 21.5362 7.25813 -26.2111 -7.67418 -8033 4 23.1349 8.01865 20.5229 -2.36131 4.58949 1.23489 -8034 6 14.3464 2.19127 18.5365 1.00479 -5.05512 -1.33996 -8035 4 14.3534 1.26337 18.7781 -10.0191 -8.45544 9.17935 -8036 4 15.2531 2.29149 18.2562 13.6881 11.5937 -7.27189 -8037 6 28.0536 31.92 34.134 3.57463 -14.0429 -1.6048 -8038 4 28.4517 32.4188 34.8607 -2.66641 5.35559 -0.0232853 -8039 4 27.3246 32.4577 33.7701 8.655 -3.68096 2.2403 -8040 6 53.3502 24.7032 18.2649 -24.2711 -41.2818 -9.83264 -8041 4 53.5194 24.6019 17.3193 6.96991 8.47211 -0.102973 -8042 4 53.68 25.5059 18.6169 17.7955 37.5084 3.34479 -8043 6 36.8031 28.4187 22.9511 -10.1554 -0.61119 21.2214 -8044 4 36.5106 28.9054 23.7358 4.15696 8.73481 -5.19311 -8045 4 36.1845 27.6911 23.0035 -2.36033 -17.8474 -9.79811 -8046 6 21.8885 30.5877 27.4793 -3.11585 8.28062 7.57241 -8047 4 22.2621 31.0993 28.2061 -3.96796 1.5816 4.48491 -8048 4 22.5937 30.5949 26.8475 10.2249 -8.24374 -18.6607 -8049 6 10.2833 3.28406 27.2289 -24.5304 -2.91212 14.6365 -8050 4 10.0443 2.76427 28.0065 14.6588 -5.9106 -2.57837 -8051 4 9.44832 3.75002 27.1066 2.80489 10.142 -13.305 -8052 6 37.7147 24.9939 29.6988 5.24245 -12.5023 -10.1121 -8053 4 38.3581 24.5533 29.0689 -23.3017 1.4918 23.5498 -8054 4 37.1779 24.3214 30.1874 12.7329 5.56421 -12.5271 -8055 6 9.13611 24.4367 14.4784 20.7258 8.96054 28.4908 -8056 4 9.04651 24.998 13.735 -5.03994 20.1658 -22.0876 -8057 4 8.726 23.6299 14.2398 -14.2121 -32.2206 -7.12291 -8058 6 52.7755 31.4643 7.39569 14.5412 -1.52098 0.484013 -8059 4 52.3413 32.1584 6.88884 0.00633314 4.2069 -4.47258 -8060 4 52.0605 30.9716 7.79316 -9.34275 -9.05133 5.36325 -8061 6 21.3287 5.44475 36.4975 17.176 -11.9485 -14.2877 -8062 4 20.7483 5.50715 37.2619 4.90115 -8.53405 7.77147 -8063 4 21.912 4.64524 36.5597 -18.1029 20.6035 4.94996 -8064 6 25.1768 37.2214 4.32574 4.31983 -25.8241 -7.35849 -8065 4 25.4326 36.64 3.57657 -1.88178 18.0132 5.09494 -8066 4 24.8685 36.5657 4.9694 -1.32139 10.7309 7.78615 -8067 6 33.9928 17.4475 18.2473 -28.4515 -0.0793518 28.5349 -8068 4 34.2921 17.0113 19.1053 -15.0281 13.9289 -20.2703 -8069 4 33.1064 17.9171 18.4165 33.1367 -21.5966 1.81969 -8070 6 37.9532 37.4932 25.2939 -37.7872 -15.4269 -20.4394 -8071 4 36.979 37.7096 25.1406 34.3292 -3.43428 9.43604 -8072 4 38.1084 36.7677 24.6487 1.47089 11.2608 10.0337 -8073 6 5.08061 4.87523 15.8431 -4.86231 -7.56388 -2.23136 -8074 4 5.78156 4.1744 15.8759 -9.54967 26.0091 2.46095 -8075 4 5.43258 5.75 16.0822 6.78608 -13.538 3.56789 -8076 6 14.1628 7.20449 7.78038 25.2379 -5.46067 -13.6381 -8077 4 13.5115 7.54153 8.36471 -22.6877 11.2017 23.85 -8078 4 13.6914 6.99143 6.96374 5.13235 0.836748 0.117842 -8079 6 24.9714 10.8522 38.0874 21.7543 24.8019 24.8971 -8080 4 25.3733 11.7327 37.9223 -2.75098 -14.513 10.3213 -8081 4 24.5811 10.6456 37.27 -22.0988 -18.3607 -37.1034 -8082 6 35.6792 7.98105 22.8098 -5.63995 -0.874411 -1.68631 -8083 4 36.3111 8.66137 23.0699 5.30437 2.23481 0.770305 -8084 4 35.3824 8.20038 21.9134 0.62108 2.61089 2.3422 -8085 6 24.7967 29.145 22.4166 8.97915 1.26062 2.6062 -8086 4 24.9285 28.4017 23.0307 -7.24415 3.31799 -2.87627 -8087 4 23.8684 29.1691 22.1667 -6.93063 -5.53381 0.128782 -8088 6 38.5003 31.6402 38.4666 0.118802 17.9484 -3.06973 -8089 4 38.5639 32.3894 37.8454 -0.598215 -11.959 -0.514206 -8090 4 38.3632 32.08 39.3134 -2.43734 -3.45212 12.1107 -8091 6 7.2246 33.2558 15.4144 3.93224 14.6297 14.7993 -8092 4 8.10558 33.3578 15.8508 -19.4169 -6.69939 -13.0108 -8093 4 7.30076 32.5035 14.7978 2.24681 10.3389 8.67702 -8094 6 43.3411 23.605 1.45378 1.24542 -6.52262 6.11498 -8095 4 43.1714 24.3501 0.858367 5.1295 -5.17404 3.37123 -8096 4 44.2208 23.7695 1.84296 -12.8059 2.13297 -8.4534 -8097 6 3.53981 32.9157 14.8686 -7.67856 -8.73615 6.98201 -8098 4 3.60397 33.2061 13.9566 0.668747 6.43783 -7.96574 -8099 4 3.81902 33.649 15.4236 5.03764 7.23473 -0.501009 -8100 6 25.308 21.7722 8.24708 3.37146 -12.406 14.7751 -8101 4 26.0573 21.1741 8.36562 1.41198 8.84323 -6.65363 -8102 4 24.826 21.6647 9.09095 -1.64121 7.89428 -12.8382 -8103 6 43.814 15.3562 17.763 -19.8802 -3.64728 -7.58039 -8104 4 43.4756 15.1225 16.8733 5.20247 0.973102 4.81929 -8105 4 44.7686 15.2775 17.7045 7.07231 -2.77487 -5.74422 -8106 6 15.7867 16.2594 16.6597 40.7179 11.0003 30.8626 -8107 4 16.4245 16.8568 16.2414 -0.344326 0.180624 1.74019 -8108 4 15.1074 16.2177 16.037 -41.8412 -2.72902 -33.087 -8109 6 31.9018 12.864 11.5221 -0.527288 11.9796 -2.61342 -8110 4 32.4715 13.19 12.2739 -15.261 0.218931 -18.2329 -8111 4 31.4408 13.5947 11.0331 13.5047 -10.6099 18.0399 -8112 6 18.2179 5.3463 10.1762 9.71532 5.2148 -18.3501 -8113 4 17.8204 5.66693 9.33813 -2.6575 -7.74782 15.1878 -8114 4 17.5556 5.18411 10.851 -9.29453 0.73034 -3.17809 -8115 6 23.0812 39.0781 10.9303 2.37609 8.25457 -4.90642 -8116 4 24.0025 38.8104 10.892 -1.10831 -0.594451 2.83356 -8117 4 23.078 39.9337 10.4697 -7.78026 -4.85412 5.47405 -8118 6 46.8678 33.747 8.76655 -5.11485 44.7451 24.4631 -8119 4 46.406 34.5339 8.40734 -0.304999 -21.98 -10.152 -8120 4 47.1603 34.1422 9.62028 2.09293 -20.2864 -11.5212 -8121 6 31.2447 39.9321 20.2226 -0.330123 -0.585472 -4.98228 -8122 4 30.8504 39.3151 19.5884 6.05804 4.05585 3.92388 -8123 4 32.2053 39.9316 20.0453 -4.95864 -1.44581 -1.12159 -8124 6 15.9016 33.0949 19.7876 25.1907 -5.52815 -22.1207 -8125 4 16.0748 33.7133 19.0349 -1.92202 -14.988 11.1016 -8126 4 16.5267 32.3265 19.6592 -15.8695 19.8556 5.2806 -8127 6 32.5654 39.9188 2.66304 17.6014 -10.2623 -15.3377 -8128 4 33.3417 39.59 3.14903 -11.9816 5.68487 0.865723 -8129 4 31.9971 40.348 3.29791 -5.42947 4.08066 9.69521 -8130 6 50.71 12.2088 3.91621 6.45352 -28.1924 -19.9843 -8131 4 51.4315 12.4725 3.33505 0.00989865 5.72461 1.55844 -8132 4 50.5782 12.8645 4.57223 -0.528152 29.464 22.8196 -8133 6 44.6954 2.75762 12.1022 0.941183 0.541095 5.21442 -8134 4 45.0772 1.91827 11.8337 7.97486 -4.13832 -5.1586 -8135 4 44.7961 2.76556 13.0748 -3.12194 1.26681 -13.8655 -8136 6 11.5119 11.9446 31.6555 0.0165034 5.87533 16.9496 -8137 4 11.2786 12.7291 32.193 1.1093 -4.42098 -1.85793 -8138 4 11.5615 11.2089 32.2952 3.49417 6.36211 -10.0029 -8139 6 4.75553 10.0442 10.5026 -0.613356 7.28818 -1.41717 -8140 4 5.04922 10.2458 11.3982 -0.190174 3.033 -2.19553 -8141 4 4.45357 10.8768 10.0827 4.22944 -8.29703 6.91569 -8142 6 17.1004 25.0221 20.585 20.8628 27.7333 -27.8469 -8143 4 16.2314 24.7196 20.7848 -24.892 -11.5638 6.73224 -8144 4 16.9745 25.5771 19.7683 4.93088 -15.3222 19.1034 -8145 6 48.1032 4.75801 14.8026 37.7024 -16.8658 7.41777 -8146 4 47.1817 4.923 14.9438 -21.3904 13.2232 -6.86149 -8147 4 48.4894 5.33532 14.1187 -17.354 1.23192 4.40994 -8148 6 18.8584 3.1094 3.41532 -17.9645 -5.092 -5.76247 -8149 4 18.4858 2.24853 3.65522 2.22195 0.198645 3.24183 -8150 4 19.7914 2.99202 3.55078 21.8001 -2.9136 1.99579 -8151 6 35.4214 26.4496 29.0479 -25.0869 -13.2406 8.30382 -8152 4 35.4596 27.2122 28.4766 3.66886 10.9927 -9.48044 -8153 4 36.2884 26.0622 29.0901 17.6032 -4.12101 -3.28535 -8154 6 32.3918 31.2203 12.8386 46.3164 14.9485 -1.56764 -8155 4 31.5927 31.2548 13.3118 -34.7781 -0.694705 18.2501 -8156 4 32.2274 30.836 11.9945 -8.46486 -12.2685 -25.2096 -8157 6 32.9972 28.3347 37.5978 -19.2694 -14.478 20.0019 -8158 4 32.1604 27.8545 37.87 25.9433 12.8245 -4.2723 -8159 4 33.4478 28.5699 38.4425 -10.0504 -3.89776 -17.7975 -8160 6 45.4943 24.785 10.3174 -24.9891 51.3938 13.5053 -8161 4 44.9436 25.3819 9.72852 18.6998 -28.2383 15.0369 -8162 4 45.6946 23.9769 9.88803 3.95472 -26.3164 -24.236 -8163 6 14.7646 31.7016 3.17106 -12.494 -4.77828 16.8956 -8164 4 14.1278 32.382 2.84257 8.55448 -13.727 9.9815 -8165 4 14.4774 31.2925 4.03575 0.781246 20.1514 -26.73 -8166 6 31.932 7.70259 4.29822 28.2629 -13.9597 32.9447 -8167 4 31.5142 6.8338 4.23667 -1.26054 0.464616 -4.26218 -8168 4 31.5893 8.26695 3.64018 -18.9284 22.0156 -31.588 -8169 6 42.5661 17.3076 32.2072 4.58091 20.9841 -12.8778 -8170 4 41.6153 17.2751 32.1225 -13.9289 -9.63208 0.974916 -8171 4 42.7549 18.1312 31.7017 7.23855 -15.1499 9.29454 -8172 6 13.801 23.1802 23.5544 20.5107 -9.18639 9.43365 -8173 4 13.5559 23.799 24.2431 -7.02941 8.57916 4.58982 -8174 4 14.6139 22.757 23.9348 -15.8084 7.21572 -12.2969 -8175 6 10.7224 7.09218 3.96878 16.2046 -14.1912 -58.7694 -8176 4 10.4615 7.01435 4.86228 -13.7845 -9.22242 34.898 -8177 4 10.4899 6.25858 3.45399 4.94204 24.1379 24.5516 -8178 6 28.7975 8.66057 17.8838 -26.4281 5.00156 -27.4828 -8179 4 29.5466 8.31163 17.3909 5.91048 -3.96826 -5.96201 -8180 4 28.1517 8.96764 17.1731 20.0585 -9.38402 22.2692 -8181 6 19.4445 29.3512 26.6402 -27.7559 12.8002 37.2849 -8182 4 18.9931 29.7086 27.4672 16.1765 -10.1498 -30.4371 -8183 4 20.3292 29.7071 26.6996 8.86807 3.45557 2.67965 -8184 6 40.676 40.9989 14.5783 -1.81287 -10.2023 17.4849 -8185 4 40.8703 41.6798 13.9303 10.8761 5.87921 -5.34291 -8186 4 41.4788 40.6754 15.0317 -0.103076 9.61372 -9.63617 -8187 6 46.2568 14.0853 31.7234 10.6503 -1.46249 4.93376 -8188 4 46.4506 13.1375 31.7184 -3.79774 3.42444 -0.601084 -8189 4 45.5065 14.2191 31.1522 -8.96365 0.976246 -7.34606 -8190 6 36.7103 36.3065 8.39844 -19.1971 -27.2559 -17.1971 -8191 4 36.3822 37.2167 8.51449 20.2374 -9.10083 14.9839 -8192 4 37.462 36.0245 8.9597 -8.83948 23.9771 2.75809 -8193 6 30.7983 32.4219 38.0908 -28.9564 1.76229 18.7871 -8194 4 31.3387 31.9445 37.476 23.2205 -2.83162 -11.1976 -8195 4 31.2894 33.1287 38.5298 9.85106 -3.61838 -6.87003 -8196 6 47.9 8.84746 10.1809 13.9026 13.2481 4.99334 -8197 4 47.2314 9.07534 9.54683 -14.9306 19.0332 -8.73943 -8198 4 48.008 7.93273 10.003 10.2061 -26.7512 4.08493 -8199 6 24.4282 17.0027 30.9766 -8.14946 0.47403 -13.61 -8200 4 23.7021 16.9118 30.3187 14.132 0.581257 9.28124 -8201 4 24.0019 17.1514 31.8341 1.66288 -1.35228 -5.87998 -8202 6 40.5039 5.09263 4.48513 -8.56504 -6.5373 -32.2613 -8203 4 41.2755 5.64065 4.37578 16.2932 9.35997 9.97847 -8204 4 40.1843 5.0523 3.55179 -2.89742 -7.45623 19.6864 -8205 6 52.5794 28.086 6.91602 -27.2154 -20.1235 6.97783 -8206 4 52.4353 28.6007 6.11552 3.94928 -0.112987 0.705634 -8207 4 51.6969 27.6552 7.08025 27.1089 14.7333 -4.60736 -8208 6 36.0629 32.381 23.6142 9.17579 -16.9148 -2.4755 -8209 4 36.5407 32.2813 22.7776 -1.15674 3.38979 7.41153 -8210 4 35.7113 33.2654 23.6252 -9.15386 11.2493 0.0331211 -8211 6 23.6552 31.8756 22.7565 -25.0136 1.00336 21.6204 -8212 4 23.73 32.5959 22.1297 15.1034 -2.64982 -11.1407 -8213 4 24.3343 31.2055 22.6866 12.2933 -0.39941 -10.0267 -8214 6 0.736598 24.4641 41.7072 -6.94393 1.55048 -19.4095 -8215 4 1.23654 24.8288 40.9522 -3.95743 -2.80997 9.51773 -8216 4 54.8325 24.2702 41.3637 13.4109 4.08216 3.5339 -8217 6 15.9721 8.97822 19.8125 19.0517 -22.613 16.6544 -8218 4 15.5497 8.29105 19.3091 -4.28185 -9.24838 -10.3339 -8219 4 15.6128 9.78815 19.5092 -16.7051 35.4763 -13.493 -8220 6 33.1656 12.5735 20.0353 32.8597 -32.3881 -24.7893 -8221 4 32.9817 11.6196 19.8453 -6.04217 28.6875 8.28399 -8222 4 34.1172 12.6638 19.7368 -32.1809 10.6792 11.3696 -8223 6 7.04894 24.9401 26.3957 -12.3425 -2.00741 -5.21086 -8224 4 6.75821 24.2907 27.0478 8.01299 -1.99342 6.24335 -8225 4 7.89161 25.3154 26.6505 10.7219 -3.29246 12.7441 -8226 6 44.479 22.5508 36.9163 -6.8399 -5.44184 13.3083 -8227 4 43.5214 22.4098 37.071 12.5044 3.3732 -3.51472 -8228 4 44.595 22.7899 36.0028 -4.86816 3.42784 -13.6235 -8229 6 39.2745 23.7032 25.1197 -32.3737 -81.7274 9.17932 -8230 4 39.5886 24.5492 24.9992 24.471 68.8814 -13.2187 -8231 4 38.7456 23.4691 24.3377 5.22396 6.33701 6.85867 -8232 6 20.3646 2.19602 36.9892 -4.85825 6.83938 3.69158 -8233 4 20.3067 1.45038 37.5971 1.4243 -8.23943 -2.36696 -8234 4 20.3942 1.88275 36.0861 3.42557 -6.35335 -2.19064 -8235 6 22.8664 19.5513 3.67104 -13.2265 5.28042 31.2857 -8236 4 22.7633 19.8561 4.6286 7.01101 -9.22167 -32.7463 -8237 4 23.7764 19.7315 3.39612 4.00916 2.85623 5.02623 -8238 6 31.705 12.5768 34.6039 18.8969 7.7197 42.0834 -8239 4 31.1026 13.3107 34.9476 21.2302 -23.3848 -5.30166 -8240 4 32.3569 12.3026 35.3493 -33.8624 17.1964 -33.567 -8241 6 12.9851 10.2105 25.0956 -25.1193 26.0078 -38.429 -8242 4 13.6149 10.0452 25.7619 22.39 -15.9831 32.7066 -8243 4 12.4963 9.40655 24.9468 1.34194 -14.9569 1.62555 -8244 6 27.2621 0.584423 13.2176 -28.6404 -16.2485 2.71576 -8245 4 27.7069 41.6292 13.1518 2.13728 8.59646 -2.51953 -8246 4 26.2847 0.395264 13.1771 23.0038 6.72582 -0.601928 -8247 6 5.66006 24.9398 13.9833 -7.43295 9.91556 10.5591 -8248 4 4.70147 24.9177 13.9802 -4.26929 -7.73667 -8.07402 -8249 4 5.82197 25.381 14.8221 8.41297 -1.15026 -0.763214 -8250 6 22.9908 17.9523 0.521723 7.02411 -25.4698 12.909 -8251 4 22.4592 18.6506 0.142784 -9.22706 3.46645 -2.83539 -8252 4 22.3527 17.3052 0.930771 13.2695 22.3169 -13.3733 -8253 6 33.0935 25.4243 5.46557 -9.38497 -10.8046 -8.60877 -8254 4 33.4966 26.2756 5.44764 14.9521 17.8538 5.01915 -8255 4 32.9941 25.2035 4.5344 -2.6207 -6.96629 2.5324 -8256 6 8.53079 7.95552 17.4804 7.64086 6.41223 -26.4035 -8257 4 9.4001 8.35547 17.2638 -9.73917 -4.33322 7.64386 -8258 4 8.4487 7.94255 18.4286 4.30191 2.70426 16.6029 -8259 6 26.8371 0.685906 2.89773 -0.256761 31.01 4.86999 -8260 4 26.7806 0.433187 3.83156 0.637082 -2.67537 2.60738 -8261 4 26.6279 1.66343 2.89109 6.9325 -26.481 -2.08778 -8262 6 50.0417 34.7142 15.6334 -23.0288 8.72534 -30.9996 -8263 4 50.5531 35.2159 14.9759 6.02412 -4.51102 12.1494 -8264 4 49.1615 34.6714 15.1751 14.0914 -5.62478 19.352 -8265 6 46.2791 4.99946 11.1196 9.7179 12.4772 -7.72995 -8266 4 45.7827 4.25534 11.4529 -10.6417 -11.5364 6.26713 -8267 4 46.9456 4.6214 10.5389 1.00953 -4.68959 -1.2994 -8268 6 33.7936 38.6123 35.3918 15.2762 25.882 47.4359 -8269 4 34.0305 39.0866 36.2411 -6.18084 -28.1229 -24.2145 -8270 4 33.6134 39.3784 34.8506 -5.42867 -1.33428 -20.4371 -8271 6 30.8282 25.8371 41.2172 -7.09757 -19.9215 -22.3179 -8272 4 31.1427 24.9253 41.375 1.19635 8.28989 4.89631 -8273 4 31.1138 26.3841 0.0263053 10.2845 10.2166 22.0109 -8274 6 50.2275 0.982033 24.4751 51.8832 -7.79127 14.7425 -8275 4 49.5671 0.561213 23.9746 -37.5145 -10.5742 -20.1648 -8276 4 51.0349 0.46072 24.2534 -17.6876 18.8276 11.0022 -8277 6 31.2908 0.710797 19.047 -2.09434 13.573 -1.22083 -8278 4 30.4487 0.672221 18.611 -14.5784 9.11804 -11.7691 -8279 4 31.2841 41.7946 19.4765 8.98672 -35.4229 20.9418 -8280 6 39.0741 29.5515 19.1276 -25.3595 -21.9961 15.137 -8281 4 38.1807 29.4949 19.565 25.109 7.94863 -12.7917 -8282 4 39.4837 28.6866 19.3452 2.49072 15.8212 -6.56848 -8283 6 21.6546 17.5955 25.8962 -6.78298 15.7545 0.118362 -8284 4 22.0482 18.4938 26.0891 -15.3421 -24.4294 -5.96834 -8285 4 20.8112 17.7106 25.4012 18.8301 2.25602 6.45745 -8286 6 35.0761 28.7988 27.4227 3.11164 -5.22767 30.3338 -8287 4 35.4099 29.4705 28.0422 -1.31539 -7.25274 0.820077 -8288 4 35.176 29.229 26.5925 2.58985 10.308 -31.8228 -8289 6 30.7102 25.4463 11.6589 -5.09223 14.513 32.8165 -8290 4 30.6059 25.8179 12.6014 3.72506 -14.6402 -39.0718 -8291 4 30.6061 26.1982 11.055 2.14208 -0.820709 7.44645 -8292 6 7.34821 15.124 12.3469 -7.98455 -28.7648 8.02815 -8293 4 6.65824 14.4547 12.1585 7.38491 7.52419 4.72727 -8294 4 7.19665 15.7511 11.658 -2.78105 24.4343 -15.0907 -8295 6 16.8417 26.815 7.05419 -24.774 6.28148 -21.5195 -8296 4 17.6138 26.5995 7.5418 30.7131 -10.23 16.3776 -8297 4 17.1302 26.9688 6.14022 -2.93816 -3.28182 4.8763 -8298 6 29.5112 33.0571 30.9901 -17.2684 21.8413 -16.809 -8299 4 28.6007 32.8494 30.6893 8.91061 -10.9491 6.08618 -8300 4 29.8939 32.355 31.5124 -6.62171 -19.0922 5.25725 -8301 6 14.1054 2.12143 30.9174 -7.90077 -11.4283 37.211 -8302 4 14.0041 2.00138 31.9209 0.0297695 4.78336 -39.0496 -8303 4 13.7376 1.30679 30.5176 6.48361 9.45743 4.44265 -8304 6 15.6593 22.2688 2.88796 -26.3773 12.8308 -8.6958 -8305 4 16.4059 21.7286 3.01985 35.1738 -16.1657 6.55343 -8306 4 15.0005 21.6175 2.62854 -10.183 2.33344 0.69621 -8307 6 23.7324 29.1178 40.9691 12.375 28.71 1.88761 -8308 4 23.2563 30.0016 40.9795 15.1309 -27.3218 0.73938 -8309 4 24.7153 29.2815 40.9372 -24.8849 -3.40565 0.339466 -8310 6 38.1289 14.1609 13.7163 11.3988 23.3452 4.961 -8311 4 37.6355 13.3641 13.8052 -15.0683 -25.2976 3.04519 -8312 4 38.877 13.9408 13.1592 7.07353 -0.711776 -7.39216 -8313 6 35.2564 26.5047 15.5196 1.21661 4.3606 12.6683 -8314 4 34.5556 26.4436 14.8616 -0.145442 -0.409522 -0.299569 -8315 4 34.9009 27.0522 16.256 4.1263 -8.75979 -17.8666 -8316 6 19.0944 34.7315 16.477 3.93496 0.874554 38.8769 -8317 4 19.5342 35.6013 16.5498 -2.87948 -9.96323 -9.99674 -8318 4 19.0181 34.4301 15.5899 3.71142 3.01681 -30.4069 -8319 6 18.1805 29.7449 35.7046 18.8444 17.1873 -3.97052 -8320 4 18.2235 30.6593 35.335 -4.4784 -20.2666 13.1463 -8321 4 19.056 29.5886 36.1261 -9.76671 1.23141 -6.47371 -8322 6 54.1188 22.2659 24.9096 4.78421 -24.6774 -19.3149 -8323 4 53.6441 21.8104 24.1769 10.121 5.11789 9.9801 -8324 4 53.5075 22.9378 25.1661 -14.3198 20.1313 5.7187 -8325 6 30.3323 10.3375 34.0061 7.35563 0.641124 -2.21855 -8326 4 29.5734 10.4043 34.5817 -14.4555 0.0376959 9.72957 -8327 4 30.8213 11.1653 34.1487 -3.17747 -4.67635 -0.590304 -8328 6 38.3211 33.8974 18.5888 -1.32754 -0.89807 -0.720993 -8329 4 38.9926 33.271 18.8539 2.22312 -19.1913 3.89796 -8330 4 38.8713 34.6655 18.5317 3.84957 24.8056 -1.31283 -8331 6 22.4809 14.1697 34.431 -22.1622 -5.27184 -37.8541 -8332 4 22.5433 13.5186 33.673 0.822047 20.8222 24.5167 -8333 4 23.1773 14.0067 35.0533 16.0768 -5.18569 10.3575 -8334 6 38.0141 0.622036 2.34694 9.03481 -5.1652 10.3599 -8335 4 37.7113 1.09641 3.1189 -18.3016 16.1314 2.00329 -8336 4 38.7028 0.120019 2.79986 6.1006 -11.8827 -16.4842 -8337 6 38.8847 41.1446 10.3004 16.8495 57.0142 -12.497 -8338 4 38.6453 0.212884 10.3117 6.47193 -33.8599 -1.337 -8339 4 38.2374 40.7573 10.8541 -26.8649 -17.5582 22.9746 -8340 6 53.4109 21.9211 38.9712 27.3607 0.0645619 -10.5759 -8341 4 53.0384 21.9801 38.0859 -10.7304 2.2749 -0.0111998 -8342 4 54.3668 22.0571 38.7395 -19.1981 -5.88632 12.9741 -8343 6 39.9872 12.7205 36.288 -8.06793 35.3321 20.4333 -8344 4 39.087 12.3834 36.3725 1.18883 -9.13664 -3.11406 -8345 4 40.4905 12.1818 35.7009 7.36107 -20.124 -19.0601 -8346 6 48.4463 17.2389 40.5967 -24.7278 4.81563 12.4078 -8347 4 47.5665 17.6971 40.4852 25.7833 -12.0744 1.257 -8348 4 48.3987 16.886 41.5134 6.10343 4.05346 -12.6042 -8349 6 32.0413 9.35688 40.0251 1.84943 -9.41379 10.5137 -8350 4 32.8011 9.3156 39.4233 -4.71533 -3.42986 0.347912 -8351 4 31.8082 8.43016 40.2864 3.98001 20.4877 -6.20043 -8352 6 31.7351 22.4909 6.36481 -11.9835 4.517 5.86255 -8353 4 31.4453 21.6589 6.79738 2.31245 15.2673 -2.59345 -8354 4 31.3521 23.2372 6.88711 4.39127 -22.2776 -7.77946 -8355 6 51.0252 2.58567 21.5888 12.0252 -3.79771 4.1956 -8356 4 51.3852 1.69652 21.8042 -1.91984 13.1306 -1.09782 -8357 4 51.7712 3.19849 21.4753 -6.25067 -9.48202 2.92476 -8358 6 13.6387 22.0486 12.1519 25.289 13.6281 9.24284 -8359 4 14.4553 22.4795 12.4841 -9.12946 -7.35477 -7.44936 -8360 4 12.9422 22.6971 12.3091 -5.69931 -0.254566 -0.690626 -8361 6 23.6098 24.0343 14.6404 -2.85842 21.3712 -30.1324 -8362 4 24.3054 24.4792 15.1401 1.72137 -5.65962 3.08819 -8363 4 23.5196 24.6041 13.8393 -4.42688 -17.9982 21.1692 -8364 6 9.32217 4.85318 31.2328 11.4746 -4.61869 -4.10735 -8365 4 8.43042 4.86168 30.8848 -9.06213 4.49291 -0.279243 -8366 4 9.25495 5.26013 32.106 -3.85952 -1.36 2.0258 -8367 6 16.6786 26.3118 18.041 -30.5179 5.83101 -14.1852 -8368 4 15.8205 26.6594 17.6987 9.23568 -14.6779 7.38956 -8369 4 17.2149 27.0871 17.9121 20.6972 11.6613 1.32787 -8370 6 5.1068 13.5155 11.5503 -9.62018 18.629 -29.2057 -8371 4 4.37741 13.3629 12.1623 -7.62379 -0.222526 0.540006 -8372 4 4.70689 13.979 10.7366 10.5209 -18.4088 37.9064 -8373 6 29.6181 23.6359 8.06142 -1.81854 7.21422 -1.70755 -8374 4 29.1888 23.4521 8.90141 0.206013 -3.23773 -0.0922606 -8375 4 29.4815 24.5976 7.98987 7.61073 -10.2969 -5.72522 -8376 6 0.801466 7.54671 27.8401 6.5354 -3.49578 -14.7683 -8377 4 0.895859 7.27352 28.7573 1.78004 -0.979843 7.25552 -8378 4 1.54585 8.15528 27.6648 -11.1939 -10.5496 5.25649 -8379 6 15.4336 9.77253 0.489553 0.922542 4.3707 -1.35473 -8380 4 16.0351 9.34865 41.7726 4.14277 -6.55565 2.56274 -8381 4 15.4857 9.31476 1.34042 4.74784 -1.15717 -0.337147 -8382 6 18.8008 0.0730809 34.105 -10.3773 -6.96418 -21.8764 -8383 4 18.5081 41.5423 33.2731 5.22569 12.9238 15.5106 -8384 4 18.5071 0.998566 34.0742 -2.68781 1.40869 -5.2752 -8385 6 18.7326 30.7673 29.1559 48.9948 -22.8293 28.8452 -8386 4 19.5421 30.7479 29.7792 -35.6741 -9.01286 -31.0748 -8387 4 18.496 31.6741 29.187 -17.0068 24.787 -0.45657 -8388 6 48.459 16.4997 36.139 1.45519 10.5028 1.01521 -8389 4 47.6111 16.9857 36.2164 10.4415 -5.87096 -2.55811 -8390 4 48.4968 16.1176 35.2432 -2.18798 4.21486 5.30298 -8391 6 43.8007 0.467658 29.2569 28.3678 -13.8677 -3.77703 -8392 4 42.8971 0.305725 29.4937 -25.3214 -1.14832 5.94808 -8393 4 44.2622 41.5592 29.5347 -3.4854 12.8866 -0.12306 -8394 6 16.7282 13.8764 21.3804 -5.85841 5.25102 8.86173 -8395 4 16.2274 14.7005 21.5266 6.94274 -6.60805 -7.01164 -8396 4 16.607 13.4327 22.2267 1.29648 -4.09529 1.45702 -8397 6 17.3848 13.434 26.2514 27.8708 0.579352 -19.8612 -8398 4 18.2073 13.6243 25.7048 -28.5107 -7.2193 21.7409 -8399 4 17.5944 12.6077 26.718 -2.1357 3.12496 0.608863 -8400 6 48.1647 10.2208 23.7049 7.80266 -18.7522 13.388 -8401 4 47.9825 10.5204 24.6118 -3.05612 1.76991 -8.97221 -8402 4 48.0139 10.9468 23.1026 -1.19683 7.34816 1.26356 -8403 6 28.2773 17.9142 17.8758 3.72989 18.9709 -15.182 -8404 4 29.0682 18.432 17.6259 -4.1904 -8.84834 4.2635 -8405 4 28.5441 17.0749 18.25 8.7895 -11.8779 5.35139 -8406 6 54.0848 38.1774 23.6862 8.79068 2.20397 4.23058 -8407 4 0.0366427 38.003 23.4974 -14.1536 0.885634 -1.20583 -8408 4 53.5245 37.5494 23.203 6.54807 -0.952262 -0.611804 -8409 6 8.48984 18.3998 11.4055 -13.462 -3.57414 27.789 -8410 4 7.65602 18.6961 11.043 -9.38292 3.75479 -0.915161 -8411 4 9.09748 18.5243 10.712 30.3826 3.02886 -30.4498 -8412 6 45.9441 12.8818 11.0222 -16.4049 1.91652 -6.40765 -8413 4 46.711 12.6299 10.4835 -7.54952 -0.564906 -6.57768 -8414 4 45.1235 12.7466 10.4771 21.7466 0.735613 7.10643 -8415 6 16.2215 8.79448 14.033 27.9098 -14.9816 6.01142 -8416 4 15.5522 9.3752 13.7952 -53.829 20.9905 -11.5495 -8417 4 16.9359 9.40542 13.9326 31.9466 3.3348 3.59486 -8418 6 42.7223 13.3863 21.3918 29.8224 16.7773 6.64199 -8419 4 41.9142 12.8874 21.2836 -9.67718 -3.29752 -8.9243 -8420 4 42.6271 14.312 21.0975 -16.0363 -11.184 0.152454 -8421 6 20.9977 40.4228 16.4707 19.2311 -21.9074 5.84064 -8422 4 20.7341 40.0536 17.3362 -0.495629 5.04161 -8.05599 -8423 4 21.8212 39.937 16.2081 -24.2166 11.8961 5.45251 -8424 6 45.6397 11.4296 32.9439 38.4109 -29.1814 -9.99274 -8425 4 46.3321 10.7493 33.2028 -28.4056 24.9384 -5.22126 -8426 4 45.113 11.6624 33.7013 -7.79747 1.97566 18.4384 -8427 6 26.9602 8.8599 24.2968 13.5915 2.79356 4.8338 -8428 4 27.3951 9.75608 24.2837 -6.20264 -27.5971 5.81865 -8429 4 27.4821 8.2415 24.8764 -5.62896 20.549 -11.158 -8430 6 18.9707 2.44141 29.3655 -2.01209 17.0873 0.653095 -8431 4 18.2519 2.38593 30.0124 -1.45633 -1.83702 1.76482 -8432 4 19.0982 3.39915 29.1871 -0.208097 -9.69202 4.76181 -8433 6 8.2396 29.1642 19.724 -7.67611 -9.48635 17.3168 -8434 4 8.16332 28.9052 20.6672 2.00381 4.74558 -18.2193 -8435 4 7.79264 28.4685 19.2154 1.97612 2.42161 3.19163 -8436 6 9.03293 34.3085 18.6392 -6.8245 -3.51508 -5.57673 -8437 4 8.73043 34.3576 19.5508 2.61936 3.47829 -5.40237 -8438 4 9.19173 35.2194 18.3614 3.83285 -0.179546 -0.301582 -8439 6 10.1806 11.9309 11.2378 5.33181 -8.21116 5.18339 -8440 4 10.4199 12.8404 10.9987 -8.38943 -3.43734 -3.26379 -8441 4 9.2213 11.8063 11.1618 4.16708 15.3888 -2.40164 -8442 6 35.7388 21.6853 36.1571 -21.2187 21.2566 3.59668 -8443 4 35.0074 22.3505 36.1843 15.9506 -16.0405 0.715421 -8444 4 36.3839 21.978 36.8321 -7.05156 -5.2756 -8.86951 -8445 6 17.0774 12.5078 36.39 -5.14261 15.8003 12.7424 -8446 4 17.3404 12.7479 37.2961 -4.35419 -1.09545 -7.6232 -8447 4 17.4977 11.6659 36.234 4.71638 -15.3379 -7.50181 -8448 6 37.1607 13.034 34.2837 0.889917 6.85814 -56.1323 -8449 4 36.6144 12.2451 34.135 3.16712 2.80772 8.73621 -8450 4 37.2953 13.1592 35.1962 -1.91867 -3.10361 40.6259 -8451 6 38.9747 29.5563 13.2253 1.18838 24.1885 -12.4362 -8452 4 38.8174 28.6959 12.8484 -2.87796 -16.626 0.178868 -8453 4 38.7606 29.548 14.1582 -0.666122 -3.30753 9.89159 -8454 6 0.17037 29.343 29.4884 -1.26324 3.91124 -27.2421 -8455 4 0.785297 28.6867 29.1327 1.78511 -2.78426 6.40223 -8456 4 54.9717 29.8735 28.6813 -2.47422 -4.8209 18.3172 -8457 6 15.9286 0.264913 12.7638 2.77369 8.97324 -0.606717 -8458 4 15.3998 0.564835 11.9867 -4.35739 -9.72902 15.1241 -8459 4 15.3918 41.7399 13.4663 -4.26125 7.58409 -15.055 -8460 6 3.98508 11.9472 8.79546 -10.0423 -23.9471 10.8905 -8461 4 4.30821 11.7435 7.92681 6.40121 -7.70989 -16.6116 -8462 4 3.96465 12.8834 8.77069 -2.75643 37.1798 9.03734 -8463 6 24.0517 23.6768 19.9772 9.9875 -0.396554 0.578582 -8464 4 23.5025 22.9354 19.7663 -8.47693 -16.0962 -5.40355 -8465 4 23.4442 24.2751 20.4024 2.14545 13.6845 6.88162 -8466 6 4.48152 2.30986 23.9923 -27.0109 23.4084 27.373 -8467 4 4.59263 2.40669 23.0716 9.73085 -3.6317 -36.525 -8468 4 3.6479 2.81506 24.1139 10.3345 -10.6947 10.8816 -8469 6 33.0856 27.6588 33.8383 -8.68317 -6.77689 0.893276 -8470 4 33.3543 28.5605 33.6822 -2.66039 14.7626 -6.22211 -8471 4 33.7694 27.2718 34.3804 4.93538 -5.90298 8.33006 -8472 6 11.4012 21.7076 6.08442 -20.9181 -7.28975 6.20623 -8473 4 12.3452 21.6439 6.06884 23.6791 -0.506282 -5.12853 -8474 4 11.1369 22.1078 5.25059 3.06155 -0.534748 -3.52863 -8475 6 37.2275 13.5312 23.6107 -13.7454 14.8127 9.96245 -8476 4 37.2011 14.0176 24.4689 -4.04457 -8.03454 -15.7104 -8477 4 38.0738 13.1109 23.5305 19.2281 -7.80113 -1.86698 -8478 6 5.00929 21.0475 33.3676 1.03993 27.0325 -33.9401 -8479 4 4.24931 21.2691 32.771 13.0002 -8.94008 10.7478 -8480 4 4.70945 20.492 34.0664 -10.4226 -16.4153 18.9759 -8481 6 18.2024 37.5737 26.9347 11.0126 -1.54132 -8.69207 -8482 4 17.8515 38.4557 27.1129 2.92195 -1.85995 -3.39903 -8483 4 18.9058 37.6892 26.2602 -8.80934 -3.84756 9.96821 -8484 6 19.7475 16.1502 4.67922 -0.59461 -5.69737 6.80756 -8485 4 18.938 15.9829 5.17999 -0.503733 6.42822 -3.53139 -8486 4 20.452 15.899 5.29485 1.51569 2.54074 -3.7554 -8487 6 54.0588 32.502 15.5791 2.11509 -30.3723 -27.0265 -8488 4 54.9193 32.2734 15.944 -2.03587 2.87368 2.60187 -8489 4 53.7148 33.1889 16.1175 -9.21817 24.1266 16.9863 -8490 6 31.1319 3.81908 36.7331 -8.52453 -12.3767 5.98224 -8491 4 31.0251 4.01663 37.6709 2.24281 6.85123 1.97341 -8492 4 30.7371 2.93942 36.6325 4.48759 4.53933 -4.77061 -8493 6 11.8397 14.3559 5.95013 17.712 13.5011 32.6048 -8494 4 11.8882 13.4483 5.64785 3.21485 -4.29204 1.16864 -8495 4 12.4103 14.428 6.79608 -23.3682 -9.2254 -38.5841 -8496 6 30.4732 33.6903 6.46877 -20.5926 30.9984 10.0988 -8497 4 30.0823 33.146 7.15741 -0.571027 -8.82817 5.88036 -8498 4 31.0368 33.1406 5.95739 18.3645 -25.6031 -16.3825 -8499 6 12.7874 0.539502 21.6719 -8.5062 -5.44338 -19.1545 -8500 4 12.0427 0.939271 21.1459 16.6961 -1.79193 22.1421 -8501 4 12.8959 0.982969 22.5241 -5.23507 7.86641 1.50036 -8502 6 52.7588 7.2218 26.198 16.8025 28.3515 6.33153 -8503 4 53.4065 7.96379 26.3423 -21.978 -17.2249 -4.05545 -8504 4 53.0631 6.80021 25.3976 -2.37526 -6.61619 -6.13258 -8505 6 39.7335 40.8867 3.73325 7.25622 8.93714 -16.4459 -8506 4 39.3445 40.0379 3.8542 -7.03998 -23.1188 -2.87281 -8507 4 39.6833 41.2661 4.59764 3.93702 15.0893 17.324 -8508 6 20.121 31.9222 21.9838 -6.71526 -6.20654 6.86321 -8509 4 19.4522 31.9772 22.708 13.7594 -4.46219 -12.9776 -8510 4 20.3423 32.8279 21.7497 1.41177 8.86705 -0.575134 -8511 6 12.8675 35.0031 4.45346 44.828 -17.7313 4.60062 -8512 4 12.2237 35.6716 4.40701 -39.658 29.9319 -2.18346 -8513 4 13.7076 35.4677 4.24983 -7.53722 -6.26381 -0.0905995 -8514 6 24.0625 33.6591 24.8433 7.47563 8.71661 -6.22666 -8515 4 23.7256 32.9086 24.3593 -5.011 -9.84395 -6.229 -8516 4 24.8651 33.8891 24.3525 -1.08488 0.504411 0.449776 -8517 6 40.1566 40.8925 22.745 3.65995 -18.1772 23.084 -8518 4 39.459 41.1173 22.1514 -10.4135 8.7075 -19.9273 -8519 4 39.655 40.5713 23.5068 11.7186 -0.819555 2.88668 -8520 6 15.5608 2.83174 38.4548 -17.961 4.93292 18.3513 -8521 4 14.8017 3.44348 38.6509 23.1729 -8.01231 -13.692 -8522 4 16.317 3.27039 38.0376 1.48109 9.53369 -0.90723 -8523 6 41.0116 9.17543 16.9495 15.4695 -4.08523 -13.4682 -8524 4 41.9148 8.77619 16.8957 -14.8555 5.86712 4.74383 -8525 4 40.5932 8.80873 17.73 -3.00249 -3.47282 8.63794 -8526 6 43.1871 41.3934 9.57744 -8.69666 -18.4537 3.1119 -8527 4 42.3844 40.9156 9.26306 10.8189 9.37287 1.53096 -8528 4 43.2581 0.273962 9.04681 -5.03874 9.79533 -5.6553 -8529 6 24.9044 37.9223 30.7828 -39.5154 -3.84946 22.9815 -8530 4 23.9949 37.8093 31.2426 42.0603 4.56965 -20.1335 -8531 4 24.7148 38.3736 29.9542 -2.24489 2.04808 -5.58176 -8532 6 2.22015 5.33054 16.4399 10.309 -8.52293 4.98471 -8533 4 1.84892 4.56193 16.8809 -9.36945 -1.25887 4.31387 -8534 4 3.13742 5.05729 16.2666 0.349453 6.20437 -4.74718 -8535 6 1.39717 14.946 19.1428 25.1228 15.6369 3.14315 -8536 4 0.624759 14.5201 18.7755 -11.3456 -6.79531 3.66607 -8537 4 1.29195 14.9418 20.1112 -7.64559 -2.97115 -5.19376 -8538 6 34.323 26.551 23.7054 -6.89575 15.1076 -7.90432 -8539 4 33.5377 26.6273 23.1515 0.482254 10.7241 -2.26295 -8540 4 34.2298 25.6735 24.0419 5.3831 -21.6418 13.1607 -8541 6 41.9187 21.8289 37.5387 -12.5221 18.6557 -0.654717 -8542 4 42.0641 21.2774 38.3263 -4.73604 7.9145 -4.0056 -8543 4 41.3184 22.5612 37.831 11.9642 -17.2916 1.51119 -8544 6 39.4187 37.6728 12.6286 4.8532 5.57593 -2.65087 -8545 4 38.7905 38.0203 13.2933 13.4683 3.10916 -9.30227 -8546 4 40.0129 38.4033 12.3216 -17.7433 -13.1833 12.1033 -8547 6 30.24 35.8848 2.88572 49.7685 -5.59713 18.4489 -8548 4 29.7974 35.0543 2.80033 -9.93294 -19.906 -6.06696 -8549 4 29.6668 36.5692 2.63166 -32.6151 32.1739 -11.9765 -8550 6 50.3574 12.2906 11.0327 -10.5999 -17.0186 -10.0309 -8551 4 50.5337 13.0768 11.5186 9.60091 28.0994 7.49192 -8552 4 50.105 11.6994 11.7365 -4.43527 -18.2768 5.14926 -8553 6 38.4177 1.51331 34.6454 7.78381 -17.0522 33.0946 -8554 4 38.2699 2.04814 33.8899 -7.54861 16.9144 -29.9652 -8555 4 38.0471 0.642488 34.4678 -6.5188 -5.83242 -9.72252 -8556 6 23.4539 32.2409 29.2188 -19.2438 22.9381 45.5983 -8557 4 24.0079 32.8299 28.7229 8.54827 0.527122 -15.0299 -8558 4 23.2413 32.797 30.0413 4.80705 -31.5817 -31.7916 -8559 6 36.5701 38.8746 8.90535 32.3223 -9.33237 29.2552 -8560 4 35.9325 39.4424 8.49935 -20.4423 23.0824 -8.61697 -8561 4 36.7801 39.1579 9.82993 -12.7327 0.605838 -19.3651 -8562 6 35.8737 15.8498 32.4386 8.92141 19.9053 -4.5399 -8563 4 36.1418 15.4504 33.2665 1.19933 -3.86396 7.25653 -8564 4 36.5179 16.5897 32.2945 -14.9335 -15.4114 1.1633 -8565 6 22.2892 21.8291 41.5841 -16.2626 10.7882 17.5339 -8566 4 22.1223 22.8053 41.6744 16.5914 -23.4811 -7.73209 -8567 4 23.1242 21.6534 41.1409 10.4107 9.35007 -4.50107 -8568 6 24.3606 38.6964 37.0146 17.4204 12.5043 -4.63866 -8569 4 25.2779 39.064 36.9978 -17.1771 -5.52971 -1.04157 -8570 4 24.4186 37.9719 37.6407 -4.78215 -9.12154 5.30794 -8571 6 45.8441 22.068 16.038 0.340293 -0.250982 -17.8101 -8572 4 46.1771 22.3609 15.1533 -8.50833 -8.1377 19.1007 -8573 4 45.4344 21.1785 15.9468 10.2139 13.0315 -4.03882 -8574 6 34.0918 26.1359 39.6112 38.0511 -8.91464 13.1738 -8575 4 33.1848 26.2338 39.3827 -25.4265 4.60567 1.8853 -8576 4 34.221 26.2032 40.5833 -12.0295 -1.62025 -11.2558 -8577 6 7.22533 36.1661 23.281 -59.3132 -5.14125 -34.652 -8578 4 7.26364 37.0581 22.9295 6.20379 9.34593 -2.3157 -8579 4 7.97006 36.0735 23.8015 59.451 -4.11437 40.0555 -8580 6 29.1637 40.7448 9.14206 -2.51826 7.72751 -13.9009 -8581 4 29.0444 40.3656 8.22324 15.9504 -2.90487 33.8878 -8582 4 29.7314 40.248 9.77766 -4.36215 -9.31282 -20.9127 -8583 6 29.3678 11.2357 1.30083 -35.1077 14.24 19.1284 -8584 4 28.4669 11.4731 0.940057 29.2946 -5.02339 11.2991 -8585 4 29.318 11.4379 2.27092 4.83193 -7.95866 -28.0539 -8586 6 30.9732 3.71267 14.0776 15.2348 -46.8383 -31.5788 -8587 4 31.4582 2.88428 14.3733 -12.5046 34.6753 7.46482 -8588 4 30.8397 3.49874 13.1133 -3.67459 15.4991 23.3176 -8589 6 29.7056 15.2804 38.2794 -11.9618 14.5562 -33.6413 -8590 4 30.2702 15.1354 39.0168 20.1567 -4.59268 23.419 -8591 4 30.0841 16.0123 37.7308 -6.59039 -15.0688 15.6005 -8592 6 36.6264 0.310111 29.1514 -5.04796 -7.83703 -2.09784 -8593 4 37.4271 0.819379 29.3706 -8.93441 4.46737 -4.0897 -8594 4 35.9914 0.856083 28.6484 15.2391 -5.29618 7.37908 -8595 6 47.6417 0.116275 23.248 13.5287 8.94531 -12.2883 -8596 4 47.0119 0.433387 23.8864 -15.3927 3.59754 12.8324 -8597 4 47.4641 41.0946 23.1357 -2.49679 -12.2922 2.24912 -8598 6 7.90637 37.1762 29.9388 8.54368 22.8184 26.8453 -8599 4 7.85301 37.2098 30.9449 3.45275 -3.37357 -41.2712 -8600 4 8.44496 37.9737 29.6897 -17.0006 -23.7003 10.0801 -8601 6 38.9296 24.2329 12.6383 15.5219 -16.6974 -22.776 -8602 4 37.9787 24.1601 12.7323 -9.9748 0.376678 1.49713 -8603 4 39.1449 23.5705 11.9215 -5.67631 22.059 20.3409 -8604 6 21.3179 26.2613 36.7933 11.7928 19.07 -1.51604 -8605 4 20.8397 25.6962 36.2015 -9.60619 -6.53459 -13.3894 -8606 4 21.5182 25.6957 37.5187 2.0605 -10.1459 21.1123 -8607 6 28.2262 23.3351 24.9913 6.08955 -0.748437 0.460504 -8608 4 28.2308 24.0016 25.6964 4.22655 -6.81745 -1.24962 -8609 4 29.0479 22.8075 25.0363 -13.73 7.51762 2.95505 -8610 6 38.3897 39.5713 14.5774 34.0997 -9.77678 18.0089 -8611 4 38.4779 38.8655 15.2987 -6.58584 29.8461 -29.0755 -8612 4 39.3026 40.0121 14.5422 -41.1029 -19.3921 -1.23505 -8613 6 26.0587 6.01626 38.1331 -7.56489 -16.2073 9.45163 -8614 4 26.364 6.92283 38.0032 14.5247 -0.467326 2.92393 -8615 4 26.7573 5.38712 38.4414 -3.391 26.9876 -7.34507 -8616 6 52.1178 17.2513 22.5128 -10.8492 5.54118 7.42996 -8617 4 52.8997 17.6733 22.1718 9.92427 15.7211 -4.0445 -8618 4 52.2219 16.3395 22.2718 -2.102 -18.0313 -4.16051 -8619 6 39.531 30.2011 31.4754 1.32431 5.33104 20.3977 -8620 4 40.1389 30.6029 32.1578 -26.1612 -12.9519 -10.6425 -8621 4 38.6407 29.9778 31.8528 28.462 12.4065 1.81878 -8622 6 19.6595 6.91666 12.7659 -14.5008 4.80913 14.0157 -8623 4 19.6887 6.47111 13.6446 7.23462 -2.42447 -18.0556 -8624 4 20.266 6.55226 12.115 5.2883 -10.9354 6.21868 -8625 6 32.4266 37.4954 40.1172 13.7501 31.88 -47.4625 -8626 4 32.7425 36.6266 39.9032 -2.48661 -20.9779 5.59445 -8627 4 32.1419 37.5817 40.9958 -11.8933 -10.3197 48.8363 -8628 6 39.7596 0.337115 6.09995 15.1421 -1.66777 24.2876 -8629 4 40.1534 1.22219 6.08152 -5.11901 -0.972083 -7.53812 -8630 4 40.1657 41.8549 6.90018 -9.37436 -2.20237 -11.3555 -8631 6 28.7751 10.1584 29.138 -2.01192 2.80513 -2.93319 -8632 4 27.8238 10.1744 29.001 -3.57801 1.81269 -4.50746 -8633 4 28.8919 9.80572 30.0274 6.34341 -2.0407 -1.56061 -8634 6 28.3442 21.074 10.6333 2.67716 -1.32955 -8.08167 -8635 4 28.7162 21.9756 10.7458 1.68682 -14.6392 -2.70928 -8636 4 28.9848 20.5267 10.1317 -8.30024 16.2649 10.4277 -8637 6 27.0693 28.6863 20.8775 28.7719 -2.37794 4.3254 -8638 4 27.7298 29.2434 21.3283 -4.93173 -3.86203 -1.8773 -8639 4 26.2334 28.9344 21.2444 -24.6691 6.36732 10.1211 -8640 6 39.6873 13.9804 33.4544 10.1398 -5.61125 10.7915 -8641 4 40.0465 13.7022 34.3167 -4.86 2.4669 -10.6871 -8642 4 38.7726 13.6755 33.4723 -5.1401 -2.85022 0.606476 -8643 6 25.4597 11.6576 34.3181 14.491 -28.0098 33.8508 -8644 4 24.8514 11.0162 34.7619 5.36553 12.2612 -15.2396 -8645 4 25.0161 12.1454 33.6493 -21.152 12.7672 -16.4478 -8646 6 27.5131 37.6326 21.427 -19.9573 -21.9997 -23.7283 -8647 4 28.2253 37.2064 20.96 8.67225 -9.05343 -17.242 -8648 4 27.9596 38.068 22.1137 20.557 20.5047 35.0331 -8649 6 30.5914 20.0695 28.6348 27.7431 -17.6396 19.2377 -8650 4 30.9836 19.3645 29.1801 11.8534 20.0629 -12.5158 -8651 4 29.6982 19.8076 28.6872 -39.6618 5.20089 -10.7407 -8652 6 42.3778 1.85684 14.9393 25.4983 -1.50621 30.9456 -8653 4 41.9471 2.41032 15.6124 -5.43016 1.03086 -4.74891 -8654 4 41.8361 1.80616 14.1675 -19.8596 2.00334 -17.6468 -8655 6 12.1616 12.5321 19.523 -14.5305 -6.69845 -4.01711 -8656 4 12.9939 12.0448 19.446 -0.641831 -5.10207 -0.17564 -8657 4 11.4028 11.9007 19.4323 17.6183 8.93718 0.635936 -8658 6 19.2173 1.21358 16.3673 12.2327 1.89672 9.92834 -8659 4 19.755 0.600796 16.911 -5.77615 9.45405 -9.5745 -8660 4 19.8129 1.9499 16.1364 -2.75311 -6.47505 -0.557351 -8661 6 9.48027 16.145 27.6887 18.4383 23.7652 -21.1678 -8662 4 9.95062 16.009 26.8224 -12.6846 -2.19341 25.2173 -8663 4 9.19893 15.3052 28.0262 -3.30777 -17.5687 0.945009 -8664 6 40.4566 26.1709 24.7821 -20.4805 41.2174 -0.532491 -8665 4 40.3628 26.7039 25.5991 10.1463 -19.7663 1.05084 -8666 4 40.0809 26.8306 24.1463 10.2053 -25.1837 1.88999 -8667 6 47.6675 17.6506 18.0225 -30.0634 41.3074 12.2788 -8668 4 48.2543 17.9981 18.7254 0.401995 -10.3127 -9.33209 -8669 4 46.9068 18.3177 18.0388 29.0716 -28.5939 -1.2112 -8670 6 36.6158 25.2629 4.18774 29.3736 28.0527 4.32129 -8671 4 36.5214 25.5758 5.09839 -16.0305 -5.04511 0.138651 -8672 4 37.2819 25.9232 3.86538 -16.6324 -17.2389 -6.3952 -8673 6 39.5728 35.3879 29.6636 12.278 22.7044 -7.26925 -8674 4 39.0499 34.5938 29.661 -5.91236 -8.06683 2.48368 -8675 4 39.3907 35.9006 30.4607 -1.7908 -9.53931 -1.38728 -8676 6 0.412001 14.6096 13.3342 2.26376 -2.5079 -14.7045 -8677 4 54.7802 15.2759 13.6175 -3.32355 6.27336 -0.974202 -8678 4 0.516441 14.0579 14.0961 4.60085 -12.9246 15.0473 -8679 6 12.196 27.3305 8.43326 10.0473 13.6833 14.0535 -8680 4 13.031 26.8669 8.51701 2.31971 -16.5604 -6.51009 -8681 4 12.4357 28.1833 8.85089 -17.0888 -3.60228 -10.1051 -8682 6 36.9057 14.8161 21.1198 30.6025 20.2317 -25.7914 -8683 4 37.0125 14.4244 21.9807 1.92342 -10.2074 20.832 -8684 4 37.7936 15.2053 20.874 -24.9082 -16.5351 5.08732 -8685 6 20.8486 4.94275 21.105 17.9022 -6.61396 -0.309651 -8686 4 20.374 5.67415 21.5228 9.17185 2.06744 3.08402 -8687 4 21.7751 4.88103 21.448 -24.8745 1.45604 -2.42669 -8688 6 36.7441 1.80601 7.63303 -8.86792 14.8212 -18.8361 -8689 4 36.3577 2.71345 7.77493 14.0998 -30.8697 16.0099 -8690 4 36.9898 1.34966 8.45182 -6.21638 14.7491 3.51078 -8691 6 12.2291 31.5076 37.4606 -20.8205 4.71929 16.9336 -8692 4 12.7789 31.2189 36.7301 -1.71439 -5.19212 -6.77065 -8693 4 11.3837 31.0118 37.4916 13.4088 3.21935 -3.86138 -8694 6 38.9875 41.6041 16.8806 -4.97036 -4.86794 -9.64455 -8695 4 39.4307 41.5716 16.0177 3.10466 0.790549 7.7281 -8696 4 39.367 0.410173 17.3903 6.57234 9.13046 2.45051 -8697 6 31.8971 27.2651 22.2536 0.475946 9.95506 -26.8482 -8698 4 31.2288 26.6192 22.5148 1.53167 3.01995 -0.700727 -8699 4 31.6701 27.5469 21.3168 1.33988 -13.0026 32.8364 -8700 6 42.7373 9.18402 25.5752 -16.5205 -8.12573 12.5156 -8701 4 42.0715 8.82875 24.9549 8.97347 3.93682 -3.18445 -8702 4 43.4726 9.55718 25.0966 9.17117 4.66181 -14.1392 -8703 6 50.9317 28.1762 25.3585 1.81467 11.9603 16.0249 -8704 4 50.4332 27.6858 24.699 -7.797 -4.30978 2.61883 -8705 4 50.6061 27.9816 26.259 1.82058 -3.16123 -16.2825 -8706 6 43.2019 19.6758 30.9261 -60.5069 12.608 18.1565 -8707 4 44.1121 19.7947 30.8273 58.227 11.7487 -4.80009 -8708 4 42.8317 20.4979 31.3452 14.2318 -14.5845 -6.94071 -8709 6 30.6579 14.0392 40.8099 -3.90856 28.8453 32.4485 -8710 4 30.2625 14.437 41.6588 6.78025 -22.1962 -33.7862 -8711 4 30.2388 13.192 40.6401 -8.31431 -9.09038 5.19898 -8712 6 20.9126 15.487 23.0255 1.81996 -1.2716 -0.577536 -8713 4 20.3529 16.1851 23.4151 9.86352 -5.06847 -1.26552 -8714 4 21.845 15.6804 23.2451 -11.0139 0.781722 1.09061 -8715 6 34.2266 0.759926 35.8266 5.91607 -35.831 36.3238 -8716 4 34.6699 1.4486 36.3596 -6.19332 -9.6922 -6.67054 -8717 4 34.0788 41.8551 36.4474 5.42693 41.8664 -30.5853 -8718 6 38.9146 36.9114 35.918 21.2173 -10.8751 17.2864 -8719 4 39.7829 37.095 36.338 -12.434 5.66027 -11.9648 -8720 4 38.7157 36.033 36.27 -5.46808 2.11761 -7.10044 -8721 6 45.1412 25.209 22.7799 -9.21588 11.7282 35.1943 -8722 4 44.1635 25.1535 22.9277 18.3683 -4.67801 -8.38153 -8723 4 45.395 24.8019 21.9606 -9.08047 -9.94082 -17.9945 -8724 6 40.6079 0.819632 35.9543 -10.1658 30.0784 -5.29357 -8725 4 40.5743 41.7978 35.9297 8.39322 -37.6139 4.80851 -8726 4 39.8853 1.04128 35.3423 10.5918 6.58535 9.58714 -8727 6 11.0481 28.354 35.0263 -7.05837 2.15472 6.15391 -8728 4 11.0065 27.7661 35.7937 6.20016 -1.50115 -1.31869 -8729 4 10.2774 28.923 35.1598 -2.00076 2.29074 -4.05614 -8730 6 20.214 13.5993 35.8619 28.0429 -16.4719 23.5579 -8731 4 19.4963 13.9327 35.3857 -45.1468 12.1599 -23.9045 -8732 4 20.9404 14.0304 35.4284 21.7873 4.64258 -6.99651 -8733 6 39.6259 5.13927 1.77541 6.3837 10.5905 23.0009 -8734 4 38.815 4.76887 1.43754 -8.89155 -4.8304 -7.9643 -8735 4 40.2998 5.10051 1.09544 5.70124 1.55861 -13.0764 -8736 6 30.2644 30.8765 32.4376 2.45351 13.5189 11.7538 -8737 4 29.6638 31.1848 33.1457 1.37952 -7.29152 -6.97913 -8738 4 29.9065 30.0722 32.0512 -6.5155 -7.29863 -0.0927806 -8739 6 14.5561 10.991 22.8667 10.081 16.7623 43.7388 -8740 4 15.1677 11.6459 23.3133 -13.9792 -18.4015 -26.7579 -8741 4 13.9431 10.829 23.6181 3.59137 -7.6484 -17.8174 -8742 6 20.7554 13.9367 3.0184 -22.7431 -13.2276 -14.851 -8743 4 19.9027 13.7405 2.57467 24.082 -4.954 3.77469 -8744 4 20.4786 14.7044 3.49738 5.42185 19.6619 18.2233 -8745 6 41.2999 4.28373 12.6115 -5.11846 11.2121 16.06 -8746 4 40.5902 3.66826 12.7964 -5.45414 -3.74116 2.1628 -8747 4 41.646 4.04628 11.766 6.8814 -9.70345 -22.8074 -8748 6 10.8486 24.7151 21.7079 -22.0181 20.7635 -2.99902 -8749 4 10.06 25.055 21.1824 26.1755 -20.3138 8.68391 -8750 4 11.196 23.8735 21.3742 -8.74412 -0.217035 -8.2032 -8751 6 53.5851 20.8962 34.3615 -20.5776 4.99959 -7.54911 -8752 4 54.5312 20.9399 34.3174 23.7346 3.60458 -0.717784 -8753 4 53.3344 20.0378 34.731 7.46747 5.54606 -4.26157 -8754 6 14.8822 4.84805 30.4483 -9.71325 -6.00753 -19.6684 -8755 4 14.771 4.94284 29.4789 1.77408 0.90497 14.7496 -8756 4 14.5561 3.94513 30.5986 4.49673 6.24836 5.5759 -8757 6 48.9024 37.1196 13.1149 -36.5603 24.8322 -14.1851 -8758 4 47.9606 37.2057 13.4129 22.1922 -3.12109 -3.19476 -8759 4 49.2987 36.4589 13.6532 13.3268 -16.5999 12.901 -8760 6 26.8059 19.3169 7.54434 -4.26945 -4.42367 7.83904 -8761 4 27.1766 18.4867 7.22339 -3.92405 -4.32352 -1.07463 -8762 4 27.3968 19.9842 7.20607 8.782 12.6164 -5.40832 -8763 6 17.6305 11.9358 39.0864 -20.6439 9.19078 16.9487 -8764 4 18.5077 11.609 39.0209 28.8526 -12.5757 -8.06323 -8765 4 17.5232 12.1203 40.0373 -6.81014 1.23205 -8.73836 -8766 6 49.927 14.591 8.61416 15.5742 -26.1486 -8.96269 -8767 4 49.2009 13.9524 8.72368 2.87529 10.9098 3.94828 -8768 4 49.6414 15.4659 8.85563 -10.1676 20.5637 7.32703 -8769 6 32.3582 34.9735 31.5167 -0.414276 11.4895 24.1707 -8770 4 32.1283 34.3825 30.8126 -1.81559 -4.89127 -12.898 -8771 4 32.4479 35.8663 31.1601 -0.97656 -3.19104 -3.1743 -8772 6 11.821 22.2226 21.3194 1.12988 -20.2292 -31.7924 -8773 4 12.2035 21.6949 20.5593 -17.646 16.3031 19.3587 -8774 4 12.5076 22.1609 21.967 14.4856 1.86701 17.8995 -8775 6 33.8479 9.95925 13.6297 5.85555 4.94861 0.641841 -8776 4 32.9412 9.60258 13.4965 20.4646 2.44791 -13.0803 -8777 4 34.46 9.81143 12.8638 -25.0852 -4.3509 9.75457 -8778 6 25.5216 36.3896 1.4985 -3.83916 -1.90754 -5.44184 -8779 4 26.1733 36.851 0.947779 -3.43756 3.58217 3.68691 -8780 4 24.6678 36.8514 1.38848 10.8858 -3.23471 -1.95008 -8781 6 26.2654 10.5456 9.75524 -44.5011 8.64206 25.1655 -8782 4 25.6084 11.269 9.60979 18.788 -4.56637 -6.88642 -8783 4 25.8198 10.0845 10.5139 21.0346 7.54764 -16.1236 -8784 6 25.0247 0.792222 40.9035 16.6629 9.7536 -9.8108 -8785 4 25.2766 0.410293 40.0414 -7.0744 -0.853038 7.71488 -8786 4 25.4535 1.67289 40.8914 -6.39875 -10.0211 5.33714 -8787 6 46.2514 3.92331 24.811 2.29787 -10.4124 3.565 -8788 4 46.4476 4.07649 23.8793 1.84574 -7.0337 -1.43198 -8789 4 46.0806 2.96577 24.928 -3.00701 8.9366 -8.52535 -8790 6 21.593 13.605 29.211 2.46069 1.87638 12.7155 -8791 4 21.5518 14.2847 29.9136 -0.977025 -6.07097 -8.18011 -8792 4 21.3035 14.062 28.4178 -1.02829 3.62716 -1.29843 -8793 6 36.772 38.3747 0.364057 -13.57 -14.6746 -5.92565 -8794 4 36.4241 39.1227 0.863015 -2.10343 5.30459 -0.282121 -8795 4 36.0255 37.7419 0.250491 13.2024 11.0478 3.68109 -8796 6 19.3024 17.6377 24.0664 34.4056 30.1631 -22.0465 -8797 4 18.4191 17.3498 24.1437 -40.9446 -15.7866 5.54764 -8798 4 19.2946 18.2748 23.3003 0.347271 -14.2409 17.5238 -8799 6 23.1729 12.6936 3.50527 -23.4203 -1.67393 -9.32385 -8800 4 22.2599 12.987 3.28408 10.1497 2.83055 6.60862 -8801 4 23.2366 11.8468 3.05081 2.04707 -0.882582 2.79058 -8802 6 37.8929 8.88926 35.4532 -15.1513 -19.5409 -35.7954 -8803 4 38.8496 8.85033 35.2802 -3.80753 -1.00094 -0.145651 -8804 4 37.4409 8.32345 34.738 24.7998 24.8105 28.8968 -8805 6 14.3214 15.124 36.1936 10.1777 -8.45579 -11.337 -8806 4 15.1189 15.6285 36.3983 0.383997 -0.909139 3.4786 -8807 4 13.728 15.2114 36.9249 -8.84751 6.7001 14.2991 -8808 6 35.0764 0.951221 33.027 4.39995 -0.747562 -23.3066 -8809 4 34.9707 1.92678 33.0471 -0.901583 -14.825 16.9845 -8810 4 34.929 0.489106 33.8671 -4.79444 18.9729 2.67887 -8811 6 50.9368 0.508345 17.9996 -16.1068 -2.11236 -10.8013 -8812 4 50.7363 1.3993 17.6607 6.59543 -7.82408 5.75367 -8813 4 50.2126 41.8571 17.6452 15.113 5.01242 7.08044 -8814 6 26.2276 30.5707 0.943679 2.98972 25.4521 29.679 -8815 4 26.9747 31.0717 1.30878 -11.5718 -5.07384 -0.177367 -8816 4 26.5685 30.1289 0.190254 7.28539 -15.5247 -23.6744 -8817 6 18.5631 38.2963 4.56281 15.0547 -0.00169581 -1.07608 -8818 4 17.6313 38.4808 4.44067 -9.04909 6.52025 -3.84653 -8819 4 19.0145 38.7079 3.79419 -7.75189 -5.39823 9.30868 -8820 6 31.1327 5.08368 4.10816 20.0095 -18.3558 -6.33253 -8821 4 31.8391 4.51927 4.54922 -26.0459 18.0586 -17.7145 -8822 4 31.2112 4.96997 3.12633 -1.20575 2.29654 19.098 -8823 6 26.4386 21.9021 1.48262 11.6176 -12.3641 -2.34526 -8824 4 26.4119 22.77 1.11333 -7.24657 26.8604 -8.21156 -8825 4 27.3591 21.6321 1.37052 -1.3799 -4.61827 0.12427 -8826 6 39.218 11.6975 22.8013 10.5737 17.0434 4.86912 -8827 4 39.8837 11.6898 23.5135 -8.12783 -9.21376 -3.17514 -8828 4 38.7576 10.8611 22.7762 -0.316566 -9.51531 5.7902 -8829 6 13.6104 36.3454 30.6448 12.2201 31.8005 15.4331 -8830 4 13.9411 37.0787 31.1944 -5.64032 -6.12374 -20.8561 -8831 4 13.4819 35.6769 31.3099 -5.82879 -19.5305 -1.97286 -8832 6 50.5737 9.8729 9.34449 -28.5439 -15.8542 -0.594603 -8833 4 49.6941 9.5296 9.68217 24.5077 10.0039 -8.16891 -8834 4 50.7802 10.6382 9.87905 1.56032 8.49656 8.37591 -8835 6 49.6568 40.2957 22.5808 3.13406 -4.17489 -1.45496 -8836 4 49.9643 39.4131 22.2832 -6.04563 10.523 5.74674 -8837 4 49.4657 40.2311 23.537 6.08697 -6.10842 -7.72776 -8838 6 7.19984 41.3227 28.8903 -1.52952 20.6044 28.9443 -8839 4 7.18166 41.5789 29.8666 2.82963 -8.74683 -37.3978 -8840 4 7.33954 0.237732 28.3754 1.09714 -11.2116 9.436 -8841 6 13.0357 18.018 25.3358 19.442 16.9905 44.3108 -8842 4 13.6166 18.1186 24.5548 -1.12298 4.17303 17.3747 -8843 4 13.5323 18.3306 26.2146 -21.9746 -20.4015 -59.5043 -8844 6 50.052 19.589 2.43093 38.9512 -4.48133 -22.8803 -8845 4 50.7424 19.2598 1.79532 -23.4729 1.49397 14.1456 -8846 4 50.5528 20.298 2.8491 -7.87613 8.00017 8.65361 -8847 6 28.349 40.9814 24.5177 14.9096 -9.01222 -0.77751 -8848 4 28.8235 40.5955 23.7606 -4.31864 4.07524 4.80921 -8849 4 27.7156 41.5877 24.1507 -14.6867 11.3415 -7.76415 -8850 6 19.4129 5.36023 29.5381 -15.1481 -17.3665 11.3948 -8851 4 20.1134 5.96028 29.2689 3.1753 8.4576 0.913483 -8852 4 18.7407 5.8353 30.064 8.44892 1.72514 -6.85652 -8853 6 35.3149 40.1584 22.2743 -5.4761 3.67764 -22.0922 -8854 4 35.6772 39.8166 23.0859 3.70556 0.822605 11.3301 -8855 4 35.3088 41.1243 22.2924 6.6179 -0.993945 11.5959 -8856 6 16.1846 33.7767 9.75922 -0.358556 8.53088 17.0233 -8857 4 15.9516 33.2005 9.03859 1.48669 -13.8429 -11.0903 -8858 4 15.6081 34.5411 9.70154 -4.21994 3.45608 -1.0308 -8859 6 17.3638 40.6569 20.2187 0.0478101 13.797 12.0053 -8860 4 17.2553 39.7868 20.6094 -1.96745 -8.64858 -4.42208 -8861 4 17.5346 41.2369 20.9867 0.609446 0.00823871 -10.958 -8862 6 20.5168 9.71855 9.57392 23.3053 8.23996 -15.5036 -8863 4 21.1612 10.0129 10.2371 -5.46071 -1.58749 -5.90152 -8864 4 19.8092 9.36498 10.0856 -20.4585 -11.5711 12.7624 -8865 6 47.4431 20.1927 21.3797 46.3705 -23.5901 12.8176 -8866 4 48.2534 19.5912 21.2825 -32.1103 24.8918 7.30718 -8867 4 46.9863 20.0806 20.5604 -17.463 -0.0836882 -22.1962 -8868 6 38.4119 40.7863 37.8131 4.58972 -16.3007 -8.86139 -8869 4 38.2015 41.716 37.7675 -2.07213 19.1933 -0.538509 -8870 4 38.1163 40.4897 38.6817 -2.89344 0.451293 5.51523 -8871 6 4.78246 1.95264 13.1142 -0.962758 -11.3299 -4.56483 -8872 4 4.86308 1.24617 12.4504 1.09441 11.0888 1.2667 -8873 4 4.58181 1.48453 13.9266 -0.88642 0.622503 9.15822 -8874 6 46.8366 29.0044 2.17213 -21.5573 10.7483 2.0879 -8875 4 46.5703 29.0979 3.11526 14.9241 -10.138 -17.8178 -8876 4 47.6533 28.5191 2.04264 7.39387 -6.09514 13.7966 -8877 6 37.4332 26.1628 25.6457 0.476866 -1.57884 -3.35254 -8878 4 37.1432 25.5044 26.2761 -1.46501 -6.7424 3.65975 -8879 4 36.6379 26.5951 25.3475 -3.92424 6.80267 -0.609098 -8880 6 27.3215 4.19863 19.437 6.03131 -5.89417 1.59018 -8881 4 28.0693 4.5088 18.8685 -19.6633 0.0824503 4.70742 -8882 4 26.4692 4.57526 19.1444 8.48727 3.90116 -6.43998 -8883 6 29.5816 35.1763 32.6702 11.3433 -15.1984 -13.0035 -8884 4 29.498 34.4257 32.0309 -0.34209 19.1564 15.9908 -8885 4 30.487 35.489 32.5363 -2.16348 -1.10322 -0.755163 -8886 6 51.6039 27.3804 34.6228 -16.2846 20.7721 3.47149 -8887 4 51.9118 26.5342 34.8842 8.46829 -31.6815 14.0056 -8888 4 52.043 27.5552 33.7939 4.07896 7.882 -12.2594 -8889 6 26.213 15.718 22.6983 4.45652 -13.2698 4.19624 -8890 4 25.9644 16.5706 22.3629 -2.74203 26.12 0.0562263 -8891 4 25.9462 15.1046 22.0171 -4.99078 -11.3651 -6.14484 -8892 6 36.1284 41.1872 15.4686 -15.9675 5.34592 -0.326298 -8893 4 35.5872 40.4009 15.2728 11.0637 0.363161 -0.898578 -8894 4 37.0593 40.962 15.4319 4.98109 -12.2962 -3.97184 -8895 6 18.4605 8.81439 11.2163 9.85092 25.9028 -2.05591 -8896 4 18.8222 8.21565 11.8732 -2.65799 -9.87079 3.83174 -8897 4 17.6938 8.4288 10.8111 -9.58752 -11.4871 -1.05984 -8898 6 30.2054 21.3176 23.2008 0.0321998 2.06754 0.100272 -8899 4 29.9991 22.2239 22.9456 -2.76699 -3.99559 -1.97847 -8900 4 29.5697 20.7243 22.7648 2.21136 7.68347 0.454199 -8901 6 22.7376 2.20942 34.8415 -7.06988 -25.8748 21.345 -8902 4 22.3263 1.32441 34.7915 6.81547 13.2405 5.99888 -8903 4 22.6443 2.51876 33.959 0.748808 17.6695 -28.972 -8904 6 12.6779 2.74229 12.3423 -3.02369 13.9186 -14.8572 -8905 4 12.6684 3.63953 11.9163 1.20981 -22.4864 12.4813 -8906 4 13.1874 2.20366 11.7175 -0.841633 0.53426 4.77071 -8907 6 24.0891 30.0714 14.5767 2.26717 -13.4561 -11.586 -8908 4 23.8674 30.8343 15.1637 -15.8173 -12.4528 -15.4046 -8909 4 23.3482 29.6562 14.0436 11.1594 27.3113 22.4963 -8910 6 0.0169515 27.9037 22.8558 -22.9231 2.02358 -4.19556 -8911 4 54.5653 28.3586 23.5905 7.88497 -1.22395 1.09473 -8912 4 54.2173 27.7016 22.3138 13.4725 -1.40758 1.11908 -8913 6 12.3768 4.48401 25.8984 -1.01368 1.72138 -1.86924 -8914 4 11.999 5.34556 25.8124 1.61778 23.022 -11.6285 -8915 4 11.6412 4.07623 26.3496 -0.520107 -24.5543 7.98643 -8916 6 50.6552 14.4595 5.90563 -9.7075 2.6569 37.2621 -8917 4 51.421 15.0215 5.71422 1.2699 0.536098 -2.53407 -8918 4 50.4862 14.5526 6.9139 5.60038 -4.97296 -46.1729 -8919 6 52.566 22.8545 20.1304 -1.0263 1.56712 -17.1158 -8920 4 52.8493 23.3468 20.8979 1.30497 -0.175929 17.7779 -8921 4 52.7622 23.494 19.4302 -3.4332 -7.01119 -2.14697 -8922 6 43.5747 16.5432 12.8706 26.1082 -6.15301 -20.1459 -8923 4 44.3581 16.1075 12.4177 -27.2623 16.7463 17.9516 -8924 4 42.8105 16.3628 12.3102 -5.85283 0.59737 -2.51971 -8925 6 15.9643 16.7491 40.5889 4.71604 31.6512 -1.38133 -8926 4 16.4157 17.2981 39.8953 -10.7397 -16.8436 16.4649 -8927 4 15.6568 17.4119 41.253 8.12177 -13.8769 -14.2686 -8928 6 23.4093 18.8548 23.8539 -16.419 -4.21219 2.12821 -8929 4 23.4427 19.3457 24.6888 0.296298 -1.81048 -2.30579 -8930 4 22.5005 18.9913 23.5305 9.65682 -2.29273 2.24785 -8931 6 46.4286 3.27372 31.8783 1.50761 -1.36157 -5.63512 -8932 4 45.559 3.26328 31.468 -2.27736 -0.687336 -10.0334 -8933 4 46.2409 3.35124 32.8099 7.04458 2.11131 4.36323 -8934 6 43.404 41.0501 12.2894 -4.74196 -21.563 6.60959 -8935 4 43.6943 41.7945 12.8025 5.82787 10.392 6.16968 -8936 4 43.4921 41.2918 11.3656 -0.276957 5.00436 -10.4807 -8937 6 7.4944 32.479 29.5886 4.16519 42.7458 -9.72808 -8938 4 8.11522 31.7905 29.7504 15.4265 -22.4366 1.70525 -8939 4 8.06583 33.2868 29.4339 -18.9062 -19.2919 1.43274 -8940 6 4.77786 31.6555 22.5097 8.01353 -0.237295 6.09653 -8941 4 5.36252 32.2279 23.0433 -12.0801 1.27555 -9.50519 -8942 4 4.10079 32.1892 22.0697 5.55495 3.82082 5.5049 -8943 6 48.8707 26.8644 2.67473 3.24755 -50.1854 9.90243 -8944 4 49.7841 26.6767 3.05593 -33.5394 4.93648 -17.7122 -8945 4 48.3402 25.9967 2.74374 27.3415 43.0547 -3.91521 -8946 6 35.3704 23.2724 21.6151 -20.572 -8.60634 18.7236 -8947 4 36.1531 22.7653 21.8467 10.3528 0.763668 -1.9928 -8948 4 35.5272 23.8633 20.8878 14.153 10.3741 -19.8739 -8949 6 9.81162 37.7752 27.3066 -7.93747 -1.88745 -15.4111 -8950 4 9.56608 38.5967 27.7736 11.3364 -13.9943 4.65066 -8951 4 10.53 37.2723 27.7168 -2.00951 8.75096 9.6206 -8952 6 6.95784 10.9804 26.0002 -14.8513 -9.26658 -13.6642 -8953 4 6.43708 10.2284 25.6287 17.7452 16.2397 9.86134 -8954 4 7.32481 10.7062 26.8445 2.87033 -7.35616 11.341 -8955 6 15.9925 34.488 38.9165 -7.91378 13.4212 -4.2482 -8956 4 16.1125 33.5888 38.5756 -0.423195 -0.537141 7.5048 -8957 4 15.8451 34.497 39.8859 4.12272 -10.609 -16.5735 -8958 6 24.136 17.3087 36.1669 -1.30362 -38.1211 0.134245 -8959 4 24.6388 17.5417 36.9612 2.54889 -4.89456 5.81445 -8960 4 24.0565 16.298 36.169 6.29988 31.3296 1.89661 -8961 6 29.9661 19.0481 5.63552 -3.51045 -24.0694 26.081 -8962 4 30.059 18.4844 6.44318 1.40084 7.89656 -22.1005 -8963 4 29.4651 19.7932 5.9612 -6.50009 17.0844 0.645364 -8964 6 41.2323 14.2118 25.8708 0.538972 29.9242 -13.4546 -8965 4 41.1167 15.1135 25.4912 3.21098 -20.1981 4.76589 -8966 4 41.3237 14.3734 26.8138 2.01946 -2.10135 6.77926 -8967 6 30.5977 17.7991 37.3648 -2.09385 13.2702 -7.29075 -8968 4 30.1274 18.3693 36.6865 13.7219 -8.47854 26.2153 -8969 4 30.6897 18.2674 38.2325 -7.09621 1.58925 -18.9017 -8970 6 36.2622 35.7606 28.8616 -21.9344 -15.8478 13.9239 -8971 4 36.666 34.9659 29.2737 0.470987 14.2463 -5.72758 -8972 4 36.9609 36.34 28.5862 17.8584 7.52692 -3.58957 -8973 6 0.186361 37.881 20.3783 -19.4052 1.06805 -13.5296 -8974 4 0.625244 37.258 20.9754 1.43275 1.23053 -1.08677 -8975 4 54.3963 37.4077 20.0073 13.2242 8.68111 6.51083 -8976 6 49.5157 39.5849 25.2719 1.34086 -27.0873 28.6785 -8977 4 49.1738 39.8396 26.1677 9.83442 -4.23573 -27.15 -8978 4 49.8309 38.6394 25.3482 -11.1501 31.2987 0.525887 -8979 6 21.6501 10.2052 29.3652 1.38747 -32.8599 -17.8213 -8980 4 21.4815 11.1062 29.1158 -2.57329 19.5966 11.1399 -8981 4 21.7962 10.0736 30.3036 1.32123 13.0863 10.38 -8982 6 36.4484 30.062 0.133613 20.0221 49.2239 1.07318 -8983 4 36.3691 29.4748 41.3122 -8.72629 -28.1564 -18.1683 -8984 4 36.9877 30.812 41.6437 -16.8233 -22.5363 23.3328 -8985 6 35.2366 23.3806 39.1473 20.2218 -67.2813 -35.6269 -8986 4 34.8925 23.3776 38.2436 -2.85003 -5.00903 7.3464 -8987 4 34.9678 24.1769 39.4749 -24.7984 75.1446 29.9953 -8988 6 25.4958 17.6356 38.7131 -1.05403 5.23051 -13.5311 -8989 4 26.2557 17.1099 38.9745 11.6052 -6.82876 2.03202 -8990 4 25.6896 18.4914 39.1039 0.551448 5.55093 4.31103 -8991 6 32.6851 1.71412 15.3757 -17.1832 -26.0249 32.2484 -8992 4 32.9133 1.90091 16.3255 -0.281287 1.06348 -22.8896 -8993 4 32.1369 0.878474 15.451 14.5551 28.5253 -7.92953 -8994 6 2.74577 26.2334 40.164 -3.83079 -17.2464 -24.8373 -8995 4 2.52975 26.8073 40.8689 -10.0885 25.811 23.4985 -8996 4 3.46379 25.6906 40.4857 13.7859 -11.3271 -3.22577 -8997 6 25.4247 39.5803 6.65235 -3.20662 25.1889 -29.4644 -8998 4 26.0108 39.0547 7.19361 -10.0861 -10.9475 13.3666 -8999 4 24.4797 39.508 6.87242 11.3389 -11.2764 10.0712 -9000 6 3.89558 2.45526 21.1915 20.3615 -74.5786 -16.468 -9001 4 3.45835 1.54866 20.9342 19.9424 46.4596 11.9477 -9002 4 3.20863 3.06758 21.3193 -35.5841 29.5388 2.2294 -9003 6 19.428 35.9937 6.17834 -35.0483 8.79483 10.2733 -9004 4 18.6638 35.8781 6.77432 14.6839 -5.07873 0.0324743 -9005 4 19.0495 36.6291 5.56439 9.71061 8.85688 -10.7695 -9006 6 53.6717 10.8593 34.7958 -7.0633 -31.3632 -8.45381 -9007 4 53.6341 10.4895 35.6991 7.39736 18.8685 -12.2464 -9008 4 53.8829 11.7827 34.7263 4.03482 19.5096 16.0301 -9009 6 51.2684 14.0949 34.672 -8.65676 -1.63762 -26.9588 -9010 4 50.7715 13.5641 33.9816 13.3581 12.906 22.4054 -9011 4 51.0369 13.7812 35.5532 -5.90867 -9.66849 3.74112 -9012 6 14.4369 40.0234 28.032 -17.7583 12.3896 33.8878 -9013 4 13.8707 39.2432 27.9284 6.73847 -3.79593 -5.43806 -9014 4 14.0697 40.4885 28.8439 14.5888 -10.3946 -25.5694 -9015 6 36.0586 40.8581 1.30985 34.3129 5.11816 -1.28261 -9016 4 35.3876 41.022 1.96214 -5.4524 5.11716 12.4526 -9017 4 36.8901 41.3246 1.61712 -30.5352 -10.0787 -2.88322 -9018 6 32.5955 21.8673 9.61487 11.2903 3.47268 22.8686 -9019 4 32.2562 21.1899 9.03409 -3.19899 -6.31213 -16.1683 -9020 4 32.8032 22.6511 9.09762 -2.66985 0.307575 -11.8305 -9021 6 53.7554 11.4583 10.0657 12.5408 -15.0223 -21.3323 -9022 4 54.7025 11.5478 10.261 -4.15933 2.55001 3.12883 -9023 4 53.7605 10.7769 9.36125 -9.51558 7.63224 9.70748 -9024 6 25.4365 2.06658 35.0039 -16.8474 18.4627 -14.151 -9025 4 25.5892 2.94197 34.5728 -1.09755 -16.5277 9.12484 -9026 4 24.4603 2.05675 35.1439 15.8828 -2.54758 -2.86629 -9027 6 38.4258 16.3759 27.0837 10.3035 -3.82582 33.4754 -9028 4 38.4229 16.0362 28.0039 4.2105 -6.34073 -14.2668 -9029 4 38.1536 17.2766 27.2341 -1.96409 14.1736 -9.55492 -9030 6 11.9898 11.8134 38.076 -13.826 -2.82892 7.4824 -9031 4 12.2944 12.4411 38.7385 15.2198 2.85174 -2.31876 -9032 4 11.0532 11.721 38.3132 2.05768 -5.32701 -10.6008 -9033 6 21.1746 40.7334 25.8979 40.4357 -13.6237 -24.6728 -9034 4 20.6698 41.4315 25.4918 -16.6357 14.348 -0.996217 -9035 4 20.789 40.494 26.7242 -19.3448 -1.94923 24.9485 -9036 6 5.46053 31.2633 28.1043 10.2831 7.82506 0.3012 -9037 4 4.85681 31.7249 27.5011 4.53193 2.9664 -2.03256 -9038 4 6.18919 31.875 28.3487 -9.19227 -4.78386 -2.03476 -9039 6 38.5722 10.4288 26.6273 1.75688 -6.42268 2.69181 -9040 4 39.2722 10.957 26.2192 0.13713 -2.38088 1.965 -9041 4 38.9883 9.93745 27.351 -0.726559 6.62326 -4.692 -9042 6 34.5654 22.2334 5.77474 -10.6824 6.04198 20.2303 -9043 4 33.6505 22.4646 6.03122 6.34024 -5.77168 -8.80249 -9044 4 35.1097 22.5906 6.49609 1.67963 -6.25138 -9.01327 -9045 6 19.5088 23.4111 8.91157 10.1707 -16.3121 14.7533 -9046 4 19.7449 23.1021 9.7973 -5.16612 6.6008 -0.0119594 -9047 4 19.9964 22.8054 8.35541 -0.106246 2.40248 -11.9056 -9048 6 19.7526 39.1673 18.9392 3.41392 2.41259 -7.44399 -9049 4 20.3112 38.9942 19.7162 -9.66179 4.90282 -1.08801 -9050 4 18.9888 39.695 19.2431 8.6955 -6.10904 -0.220035 -9051 6 19.0066 16.6479 37.8897 24.9266 -16.0788 2.00499 -9052 4 18.1904 16.5622 37.4269 -20.8911 -0.0800444 -12.5516 -9053 4 18.858 17.3198 38.5387 -2.83386 13.0664 11.2213 -9054 6 46.1457 18.3015 34.4662 -13.7163 3.02283 10.6817 -9055 4 46.1788 17.7584 33.6837 2.50627 -7.36872 -12.652 -9056 4 45.2295 18.6352 34.4793 7.83367 -3.11582 0.242547 -9057 6 37.6724 4.92727 10.6572 20.6306 -0.498941 -29.5329 -9058 4 38.5268 5.23995 10.2493 -20.9001 -6.48587 16.5696 -9059 4 37.1025 4.69637 9.88262 10.9132 7.05613 26.3995 -9060 6 51.9879 36.0003 6.84307 -0.0349375 1.28893 10.7684 -9061 4 52.0937 36.793 6.30051 2.19835 -5.62517 4.5242 -9062 4 52.7425 36.0295 7.48232 -7.26034 2.01661 -20.7899 -9063 6 26.6747 12.3215 0.993928 -15.5873 -26.456 -19.7503 -9064 4 26.4829 12.3908 1.92985 -0.4811 3.80705 11.7504 -9065 4 26.1241 11.5295 0.732228 15.7893 19.669 4.48242 -9066 6 51.344 35.7707 13.5244 -1.45768 15.8539 -2.86245 -9067 4 51.4515 36.3837 12.7824 1.55721 2.40741 1.90229 -9068 4 51.4783 34.9191 13.1366 6.57206 -21.9808 -6.55402 -9069 6 1.98876 3.63996 24.5779 3.53339 50.093 -23.5227 -9070 4 1.66274 3.05681 25.2088 -14.7773 -39.8355 33.4132 -9071 4 1.68527 4.50485 24.9411 8.95614 -12.6616 -11.2736 -9072 6 33.5242 15.2767 16.4494 0.0755523 4.59339 -41.038 -9073 4 33.5553 15.5138 15.4787 -3.36737 -9.15609 28.4742 -9074 4 33.81 16.089 16.8707 2.78154 5.67933 12.8052 -9075 6 10.7376 26.5972 37.3568 -53.543 46.6204 -3.13137 -9076 4 10.2745 27.0143 38.1249 4.48347 -4.84659 -12.5134 -9077 4 11.4659 26.2171 37.7527 59.8403 -33.1666 26.4091 -9078 6 39.618 8.36935 32.0025 -18.1555 9.41152 20.5333 -9079 4 39.1948 8.91554 32.6893 14.8148 -9.04413 -3.7523 -9080 4 39.059 8.55692 31.2545 -3.75745 -0.899113 -17.0741 -9081 6 48.8678 24.2325 11.5968 8.56011 -30.9839 -7.0275 -9082 4 49.2355 23.3258 11.4382 -10.5357 21.2684 5.64902 -9083 4 49.6052 24.6956 12.0119 -1.11745 3.30341 0.0123828 -9084 6 15.7966 8.52145 22.5402 1.04041 9.04678 1.57429 -9085 4 15.9271 8.56462 21.5825 -0.708828 -3.15413 5.43528 -9086 4 15.5351 9.42629 22.7739 -0.982858 -3.13072 -0.606507 -9087 6 16.9647 23.5461 7.94634 -33.4976 4.63454 -7.56842 -9088 4 17.0449 23.8842 7.03772 17.2153 -3.19264 11.7182 -9089 4 17.7681 23.4723 8.45101 25.4501 5.7081 -7.03081 -9090 6 42.4788 26.856 6.32162 3.09129 16.6976 -8.96027 -9091 4 41.8509 27.5547 6.55233 4.05081 -5.7053 1.31186 -9092 4 43.1337 27.3683 5.79469 -5.76138 -9.42264 4.17624 -9093 6 36.7899 4.80361 30.039 -6.11534 9.52442 2.68488 -9094 4 37.0233 4.89717 30.9689 4.03122 4.23205 -0.240484 -9095 4 36.2783 4.00567 29.9694 -7.15291 -10.8132 -0.980928 -9096 6 45.6188 11.6101 3.31184 17.0103 13.4398 12.4748 -9097 4 45.8378 10.6807 3.43524 1.11174 -8.0511 2.33471 -9098 4 46.2756 12.0957 3.86714 -12.3909 -9.3108 -12.4209 -9099 6 24.8953 36.3829 21.2888 -10.2051 -4.79955 -3.81503 -9100 4 24.4947 36.4635 22.1668 10.8854 5.06826 1.45383 -9101 4 25.816 36.6689 21.3407 0.621807 2.11968 6.76072 -9102 6 31.8152 24.7333 2.44905 16.2387 18.0677 -0.666362 -9103 4 31.5926 23.846 2.71622 -2.49338 -12.6998 4.18613 -9104 4 32.794 24.7683 2.43834 -16.3068 -2.39725 -1.0987 -9105 6 24.1315 21.9864 37.2328 -11.9778 41.7246 15.7453 -9106 4 24.1531 22.9879 37.1682 1.73438 -35.6656 2.36813 -9107 4 24.6319 21.6756 36.4808 8.45953 -1.72708 -12.6617 -9108 6 37.1993 11.5451 15.0492 16.5469 7.10484 -0.527568 -9109 4 37.9299 11.7412 15.6355 19.6925 -10.3737 -3.43176 -9110 4 36.5282 11.9944 15.5291 -36.4248 10.8574 4.75341 -9111 6 36.4804 20.3298 41.7865 -14.7619 -38.0306 11.4639 -9112 4 36.2972 19.4996 41.306 -2.7681 3.32899 7.9346 -9113 4 36.9128 20.8369 41.1399 19.1888 26.5648 -23.5244 -9114 6 32.0378 37.9251 32.6621 -20.5074 -27.3147 -8.21436 -9115 4 32.5159 38.6908 32.9558 4.48721 20.2349 -0.22713 -9116 4 31.3298 38.1855 32.0457 8.6638 5.37323 8.26506 -9117 6 12.0353 39.9275 22.5179 -19.9222 21.97 13.043 -9118 4 12.3148 40.8142 22.1582 -9.65836 -22.9721 12.3921 -9119 4 11.2968 40.0749 23.1753 26.4497 -1.81786 -22.4595 -9120 6 26.3421 1.33641 19.2861 18.8224 -12.0939 15.9617 -9121 4 26.8564 0.711595 19.8557 -14.3211 16.2919 -14.6989 -9122 4 26.7977 2.18849 19.3545 -2.53714 -0.144297 -3.51109 -9123 6 5.91333 14.3058 5.68279 5.58536 -17.6781 -26.1831 -9124 4 6.35226 14.1008 4.80839 -10.2521 5.5819 21.3359 -9125 4 5.1498 13.7016 5.72209 7.95548 1.62414 0.442017 -9126 6 13.3681 23.0924 19.1542 -7.87238 10.4677 13.234 -9127 4 14.1204 22.8148 18.6592 15.6827 -8.39443 -13.4152 -9128 4 13.7622 23.5769 19.9007 -5.90355 -3.89356 -3.96922 -9129 6 23.3981 15.0775 9.7431 -16.2896 3.15659 0.0853289 -9130 4 22.5416 14.6758 9.94236 4.38356 -3.66538 1.71341 -9131 4 23.1926 15.7004 9.03099 5.43777 4.93098 -2.67512 -9132 6 49.5886 13.8369 18.4468 -1.57371 0.160736 10.1606 -9133 4 48.8725 13.4353 17.9701 -17.3578 -11.6866 0.338485 -9134 4 50.0711 14.2256 17.7358 20.2332 17.1818 -14.445 -9135 6 41.7455 5.66741 41.8995 19.0031 1.14603 7.86728 -9136 4 42.5946 5.93333 0.438032 -19.5636 -6.95293 -12.6597 -9137 4 41.9891 5.05837 41.1762 -2.65724 5.24908 4.18535 -9138 6 17.2511 35.5417 2.55548 5.2045 0.397579 1.12894 -9139 4 18.2067 35.619 2.48098 6.39755 9.05508 3.07921 -9140 4 17.0886 34.6316 2.34229 -4.27489 -11.2961 -3.02567 -9141 6 49.7041 19.8589 40.2412 43.8428 -27.8149 3.09893 -9142 4 49.318 19.0163 40.5437 -5.31641 8.5833 -2.14336 -9143 4 50.6864 19.6533 40.2493 -27.6084 12.6334 -3.24012 -9144 6 38.3071 5.82731 32.0534 -20.9946 -3.84451 12.3853 -9145 4 37.8352 6.48986 32.6009 6.6943 -7.79079 -6.23381 -9146 4 39.2094 6.1245 32.003 13.4939 6.60324 0.292563 -9147 6 16.2694 6.84865 34.0054 -5.49782 1.82896 8.85162 -9148 4 16.5828 6.71308 33.1028 9.77351 -3.29618 -0.21352 -9149 4 16.9894 6.61948 34.6288 -2.86373 0.259786 -9.19674 -9150 6 33.6805 18.2019 10.4544 40.2358 -26.4835 -11.4715 -9151 4 34.2537 18.8203 9.96489 -9.74865 -7.15313 7.53482 -9152 4 34.2179 17.3378 10.5117 -27.819 38.8859 -1.78852 -9153 6 38.8962 33.7675 36.7566 23.6769 3.34821 -39.6603 -9154 4 38.383 33.5793 35.9171 9.63189 4.7017 21.543 -9155 4 39.855 33.8637 36.4612 -29.1237 -5.01255 9.39617 -9156 6 45.367 13.0954 20.2202 -17.4715 7.54819 27.7127 -9157 4 45.262 12.6289 19.4029 4.78427 -8.6457 -19.3619 -9158 4 44.4728 13.0498 20.6095 8.33403 2.77458 -3.46579 -9159 6 36.394 32.2025 8.83838 -5.39961 -0.779561 10.8196 -9160 4 36.3766 31.4559 9.45045 4.37642 -0.919546 -0.394048 -9161 4 35.9671 32.9207 9.33542 2.20851 -0.984819 -7.57369 -9162 6 7.93081 27.8143 6.16526 -1.31132 8.47671 -18.7581 -9163 4 8.2701 27.2941 6.88743 5.87236 -5.84072 6.56369 -9164 4 8.18271 28.7096 6.41539 -7.71007 1.94397 -1.55613 -9165 6 14.2797 4.87717 33.6823 -38.1616 11.9775 -32.0892 -9166 4 13.6477 5.2447 32.9846 23.9092 -16.4836 27.177 -9167 4 14.8408 5.63056 33.8658 12.4601 7.15131 6.13949 -9168 6 12.2578 8.65243 9.85848 -4.82715 -2.24662 -5.48477 -9169 4 12.6456 8.73928 10.7118 23.7259 9.48722 19.5525 -9170 4 11.4378 8.2214 10.089 -13.622 -8.47682 -13.9839 -9171 6 29.7261 31.9842 8.54243 -17.2145 25.3825 -18.7463 -9172 4 30.1804 31.833 9.34913 11.7892 -12.8324 21.9258 -9173 4 29.6399 31.1708 8.03663 5.85846 -6.51984 4.51241 -9174 6 22.3891 10.8785 21.4662 8.73739 -5.18702 6.55753 -9175 4 21.8037 11.1386 20.7714 -14.2177 0.338512 -24.4291 -9176 4 22.2091 11.5521 22.1168 2.36988 5.22793 14.1218 -9177 6 54.1797 27.5396 12.9955 26.3988 -18.3584 17.6139 -9178 4 0.160041 27.5787 13.0909 -6.71045 -5.06664 4.99497 -9179 4 53.9798 28.2721 12.4475 -15.7222 27.4826 -22.0497 -9180 6 7.71973 13.812 20.0407 -34.9077 17.0186 -30.9147 -9181 4 8.32362 14.1503 20.6766 20.1403 8.526 22.156 -9182 4 7.35968 14.6399 19.6101 8.73645 -26.5601 8.16532 -9183 6 19.7932 0.841243 24.7869 -1.21084 18.2021 12.2367 -9184 4 19.1669 1.06895 25.5104 7.86649 -0.445713 -11.3386 -9185 4 20.4073 1.61074 24.7031 -15.4775 -18.2332 3.4978 -9186 6 3.01312 10.0986 2.94829 -27.2997 12.089 -8.88269 -9187 4 2.52802 10.9508 2.83041 12.1807 -20.5661 3.67701 -9188 4 3.91304 10.3154 3.17839 17.025 6.36995 4.07131 -9189 6 15.8857 13.0124 24.0049 15.5529 -4.67501 -5.43243 -9190 4 15.0856 13.5308 24.0834 -5.13718 6.9751 3.63726 -9191 4 16.3233 13.139 24.8614 0.105722 -2.17465 -3.852 -9192 6 17.0852 4.33969 26.9167 21.5143 -4.09641 1.48348 -9193 4 16.9912 4.27513 25.9666 -0.355278 1.74978 -10.9716 -9194 4 18.0601 4.31538 27.0472 -16.9044 3.21714 1.83131 -9195 6 33.6168 39.4091 10.6433 -2.74936 14.5855 -32.8438 -9196 4 33.9454 38.5625 10.8616 8.60753 -33.4012 17.9817 -9197 4 33.8375 39.4354 9.68976 -8.01757 16.2593 11.171 -9198 6 36.2326 1.10755 13.0941 -10.1125 -3.31802 -5.56412 -9199 4 35.6506 0.392496 13.3579 -10.7819 -8.26966 -9.36682 -9200 4 36.7599 1.20112 13.8707 17.1874 9.72194 12.3054 -9201 6 40.862 19.2925 5.11158 -0.402197 -15.9333 44.5432 -9202 4 40.3871 19.4968 4.34679 -15.032 12.6888 -52.1674 -9203 4 40.1189 19.1611 5.72143 13.4548 0.976419 10.4775 -9204 6 2.35452 37.5497 10.1778 32.5589 0.132829 19.8916 -9205 4 3.04634 37.0953 10.7141 -10.4583 9.64478 -9.40166 -9206 4 1.85979 36.8581 9.75685 -15.4906 -16.9123 -13.0897 -9207 6 8.10293 29.0334 15.8847 29.3895 -23.7333 0.542295 -9208 4 9.03551 28.6824 15.7668 -29.6945 17.5799 0.572456 -9209 4 8.18484 29.8326 16.4072 3.85606 5.10463 3.42896 -9210 6 47.3132 26.514 12.5427 4.56821 28.1849 -37.0073 -9211 4 47.5111 27.2634 11.8891 -8.56493 -28.9528 31.2783 -9212 4 47.3519 25.7475 11.9556 -1.34676 -3.33794 4.54904 -9213 6 33.5886 17.4994 0.666432 -7.15301 -2.01744 8.51284 -9214 4 32.6196 17.5968 0.930917 31.8637 -19.8727 -7.43903 -9215 4 33.9404 16.5735 0.747207 -21.2256 15.6146 2.50609 -9216 6 38.9757 15.6004 36.3686 4.31005 -11.6982 -11.4703 -9217 4 39.1719 14.652 36.4294 -3.02079 4.3409 1.02949 -9218 4 39.3764 15.8813 35.5317 -1.53099 5.14915 -0.246696 -9219 6 34.8198 34.351 9.37266 2.46578 -22.7668 -16.8875 -9220 4 35.3506 35.0289 8.96724 14.9634 11.0695 -15.2613 -9221 4 34.4558 34.8191 10.0913 -19.5236 18.4179 34.8179 -9222 6 44.9681 2.58102 14.7874 21.8703 21.498 2.75759 -9223 4 44.0383 2.44896 14.9383 -16.9502 -5.72583 1.77575 -9224 4 45.1679 3.47323 15.1264 -3.49788 -5.23458 -3.46791 -9225 6 42.6138 38.2902 19.8325 18.6047 12.1973 -29.2276 -9226 4 42.7029 39.1598 19.3445 -0.0117609 -27.8329 13.7468 -9227 4 43.0921 37.6383 19.2425 -13.1736 20.1758 17.0781 -9228 6 18.6869 26.7647 30.2619 -33.6624 -6.012 -17.6355 -9229 4 18.1258 26.7596 29.445 14.3051 -0.674317 21.614 -9230 4 19.5687 26.9499 29.9621 19.5047 4.84041 -5.57389 -9231 6 38.8661 37.7421 16.4836 -9.78438 -6.51051 7.80135 -9232 4 38.7478 36.8102 16.2377 -7.01003 6.44463 1.75037 -9233 4 39.8105 37.8446 16.5724 18.1337 5.4462 2.51551 -9234 6 49.3017 9.82081 12.5377 12.9664 18.8416 30.0962 -9235 4 48.8085 9.39111 11.8826 -17.6666 -23.7062 -38.8329 -9236 4 48.5984 10.2345 13.0427 4.42646 9.01279 7.79627 -9237 6 43.2246 7.36268 19.8264 -1.99344 11.167 24.993 -9238 4 42.5572 7.81175 20.4051 12.7818 -10.9207 -14.0727 -9239 4 44.1025 7.51179 20.2375 -5.96789 -3.6213 -7.06723 -9240 6 36.3461 38.714 4.42821 -2.77728 9.11116 8.98737 -9241 4 36.8002 39.5234 4.70824 5.05063 -6.10698 -1.49424 -9242 4 35.4394 38.9016 4.68929 -3.84434 -7.68842 -3.54296 -9243 6 27.8 17.802 15.105 0.992317 -7.44098 -8.78046 -9244 4 27.5393 16.935 14.729 3.58787 16.6938 2.50389 -9245 4 27.8517 17.6781 16.0585 0.147204 -0.130556 3.13955 -9246 6 18.0837 3.77506 37.3201 -10.3169 -12.5791 -10.2966 -9247 4 18.6663 3.07474 37.0146 -2.03685 -5.25132 -4.70316 -9248 4 18.6637 4.19691 37.9324 10.4473 20.1285 21.3871 -9249 6 7.71395 11.575 6.52222 6.59834 -21.2687 20.1659 -9250 4 7.75955 12.4254 6.93969 -0.705235 13.257 9.50392 -9251 4 7.66936 11.739 5.5978 -3.42683 1.36071 -31.338 -9252 6 31.4909 14.3449 18.0451 -1.46982 -12.276 17.176 -9253 4 32.1287 14.6507 17.397 7.38292 5.65775 -7.44504 -9254 4 32.0331 13.8785 18.7146 -6.90734 4.25576 -5.30331 -9255 6 50.3346 30.4143 8.91505 10.1635 2.25064 -1.90936 -9256 4 49.6557 30.853 8.39615 -4.47176 4.28708 -1.87566 -9257 4 50.0231 29.531 9.11356 -2.73977 -1.84009 2.34474 -9258 6 42.1686 10.1057 12.759 16.2008 2.03437 -4.20809 -9259 4 41.2649 9.83209 12.6487 -17.4225 -8.81494 -4.74081 -9260 4 42.1292 10.8861 13.3105 -1.28453 5.18814 5.66853 -9261 6 37.773 3.09539 32.5582 -5.24906 4.78867 -2.39206 -9262 4 38.0736 3.99724 32.5969 21.7942 11.3719 -4.3192 -9263 4 36.8519 3.25822 32.7463 -19.4678 -11.9252 3.55114 -9264 6 35.7586 13.1005 19.2721 9.99017 -22.7528 0.0781354 -9265 4 36.1308 13.8223 19.7887 2.26592 2.2719 5.61144 -9266 4 36.2509 12.2915 19.5517 -9.66412 15.3645 -2.5809 -9267 6 45.5318 4.12684 21.4944 7.1153 -16.224 0.922187 -9268 4 45.5588 4.23252 20.5315 -1.8039 6.94223 3.67507 -9269 4 45.7548 3.18328 21.6122 -5.15542 13.2346 -0.821742 -9270 6 16.876 1.8608 31.4782 -3.84426 -17.9183 -35.0426 -9271 4 16.0621 2.17388 31.0004 15.6258 0.929179 27.3362 -9272 4 17.1381 2.25043 32.3174 -12.6393 14.1325 4.42374 -9273 6 14.0947 4.88307 23.5769 -10.6061 -28.6131 16.0669 -9274 4 13.8059 5.76888 23.7237 -2.25817 32.588 -6.82267 -9275 4 13.6039 4.42137 24.2892 9.04813 -2.88937 -11.9208 -9276 6 38.3208 33.7635 12.3625 -16.3318 -7.70706 -26.0192 -9277 4 38.1373 32.9408 11.8506 0.297782 14.7405 12.2413 -9278 4 39.1486 33.6221 12.8093 16.0136 -1.39994 11.7584 -9279 6 35.6849 3.05753 37.6719 3.72695 1.1389 -16.7638 -9280 4 35.1101 2.5063 38.212 -4.0587 0.687226 6.19097 -9281 4 35.8854 3.87289 38.1447 -1.86413 5.08658 8.8135 -9282 6 31.3385 37.395 35.3723 -12.2239 -8.91609 34.0312 -9283 4 32.2231 37.7249 35.5382 9.93962 6.70229 -3.55138 -9284 4 31.225 37.4524 34.4409 4.86335 0.993516 -31.3389 -9285 6 52.0614 11.7324 14.0182 20.1458 -4.7001 -39.6215 -9286 4 52.0268 11.0667 13.2735 0.495691 14.4049 24.809 -9287 4 52.7095 12.4171 13.7023 -24.8081 -17.2766 13.6147 -9288 6 26.3478 3.42613 41.0189 1.80794 1.58056 -19.374 -9289 4 25.6151 4.01507 40.9203 -25.7718 5.99951 16.8165 -9290 4 26.7914 3.68675 40.2055 22.5797 -12.3384 -0.204994 -9291 6 24.3802 34.9453 11.1613 28.8325 38.7039 -6.19962 -9292 4 24.3515 34.6784 12.0652 -4.50215 -14.1529 28.2178 -9293 4 23.9023 34.3202 10.6558 -20.492 -31.6724 -14.1682 -9294 6 32.0094 7.59293 31.2147 -3.26399 8.81733 5.62682 -9295 4 32.0976 7.47613 30.2777 2.1706 -0.778595 -17.1478 -9296 4 31.5266 8.43606 31.2858 0.565291 -7.84955 4.65821 -9297 6 28.7282 2.60805 0.424377 -15.1279 1.50585 -5.39222 -9298 4 29.2952 2.36387 41.5859 -5.33248 3.35197 5.42737 -9299 4 27.7901 2.65331 0.119401 23.4632 0.0509354 2.06419 -9300 6 42.125 19.2126 9.86039 10.7783 -7.26578 33.4177 -9301 4 42.6695 19.2101 10.7019 -20.1092 0.869002 -30.5597 -9302 4 41.4363 18.5278 9.96356 3.48727 6.10561 -4.25932 -9303 6 33.0194 27.0842 8.32851 16.6372 -6.55357 -10.7525 -9304 4 33.8911 27.0001 7.90493 -7.38323 -0.765342 -2.5624 -9305 4 33.2437 27.3744 9.20899 -0.425855 7.33259 11.2137 -9306 6 4.16433 8.30018 19.1575 16.0783 -2.51395 5.95143 -9307 4 4.71165 7.98099 18.3991 -19.3854 5.29846 8.38252 -9308 4 3.22273 8.32359 18.9288 3.05712 -5.28108 -12.2975 -9309 6 20.7745 29.1912 37.0609 -25.9123 -20.3491 -5.83769 -9310 4 21.0713 28.277 37.0594 -15.1664 -12.7508 0.5123 -9311 4 21.6013 29.5933 37.1743 32.957 35.4267 8.73191 -9312 6 13.1089 4.99809 10.9103 2.80775 13.1965 -7.17841 -9313 4 13.4591 5.85092 11.2415 -2.5949 -14.1267 -1.88178 -9314 4 12.7051 5.16456 10.0462 -1.2434 3.82389 2.90473 -9315 6 37.5087 18.1031 32.5343 20.0502 31.699 14.1692 -9316 4 38.1018 18.8164 32.1735 -18.2411 -21.7333 4.56216 -9317 4 37.2041 18.4813 33.3903 1.90105 -7.17599 -12.7275 -9318 6 17.7655 33.2839 30.7231 12.9967 19.9173 -17.9311 -9319 4 17.8488 34.0437 30.1253 -3.68331 -4.50715 1.49576 -9320 4 18.5638 33.345 31.2563 4.57995 -0.934488 4.72964 -9321 6 23.1969 32.7832 9.90135 2.14033 10.4984 -5.43395 -9322 4 23.4737 31.9362 10.2634 3.28964 -4.66398 1.33779 -9323 4 22.2469 32.7196 9.72631 0.753558 0.42269 -0.434072 -9324 6 14.8911 9.35828 34.246 -8.54616 0.784134 0.501674 -9325 4 15.4672 8.59016 34.1372 5.2294 -0.0873347 -3.8795 -9326 4 15.23 10.0905 33.7027 2.53244 -1.05206 0.202563 -9327 6 31.1203 39.3599 38.5719 4.30147 -17.578 8.21172 -9328 4 31.5941 38.6377 39.0527 -10.1026 17.4492 -9.05875 -9329 4 30.4019 38.9077 38.1077 1.84332 2.82409 1.03593 -9330 6 5.29005 34.4279 28.2716 -0.764315 -10.945 -9.90403 -9331 4 5.24266 35.3772 28.447 -0.427568 -2.02335 -2.15628 -9332 4 5.18384 34.3192 27.3143 2.05225 4.04935 9.99949 -9333 6 30.3216 21.6974 14.1256 3.24994 1.03129 -0.468005 -9334 4 30.4656 20.7696 14.235 0.884625 -14.9253 16.053 -9335 4 30.3519 21.7638 13.1772 -0.963709 16.3006 -15.7103 -9336 6 23.8542 39.0018 28.2919 38.6077 23.8437 -8.99828 -9337 4 23.8505 39.6937 27.6143 9.44649 3.56781 3.51793 -9338 4 23.0185 38.6309 28.1896 -50.029 -28.3524 0.952356 -9339 6 9.61332 13.5451 16.4567 13.7131 10.5156 -25.323 -9340 4 8.77595 13.0917 16.3907 -9.93448 -5.52821 8.41851 -9341 4 9.74204 13.8378 15.5322 5.69689 -3.544 12.5309 -9342 6 25.9753 6.18174 15.7989 23.4837 -9.67411 23.9067 -9343 4 26.0218 6.10484 14.8454 5.11216 -1.95092 -7.71856 -9344 4 26.7445 5.66727 16.1761 -27.6477 18.1551 -17.3833 -9345 6 15.9921 33.6419 22.5616 2.25497 8.86036 -26.9911 -9346 4 16.0049 34.0594 21.6804 -4.22455 0.568633 15.0409 -9347 4 16.1032 32.7157 22.281 -1.05219 8.42244 16.6761 -9348 6 40.6812 13.5416 12.1266 -4.5396 -12.3661 6.74099 -9349 4 40.4134 12.947 11.4149 -4.75912 -2.4644 -8.17888 -9350 4 41.058 12.9332 12.7776 -0.386087 8.79442 1.8157 -9351 6 35.5875 40.2809 31.6993 12.2791 -13.6127 -29.8257 -9352 4 35.948 40.913 31.0681 -4.17713 12.2213 7.17402 -9353 4 35.6271 39.4709 31.1475 -9.59473 3.36029 20.1077 -9354 6 19.3493 17.5927 17.849 24.123 48.8902 3.26857 -9355 4 19.9577 18.423 17.9915 -34.5112 -38.8316 -9.06029 -9356 4 18.6928 17.806 17.1645 6.15508 1.01267 5.31501 -9357 6 7.96541 28.082 10.7737 20.0283 17.3944 8.50509 -9358 4 8.43659 28.8341 11.2297 -13.1431 -15.7733 -11.3814 -9359 4 7.20109 28.4458 10.3015 -0.215648 4.06143 0.688545 -9360 6 32.1489 39.5869 16.6475 -7.37335 1.81146 -4.92627 -9361 4 31.705 40.4043 16.3332 3.90743 -15.5774 4.53996 -9362 4 31.4977 38.8659 16.5723 3.01217 10.596 3.08762 -9363 6 35.8095 2.63602 18.127 2.07542 -14.8225 4.13142 -9364 4 34.8947 2.32962 18.1713 7.15775 -3.6283 3.09768 -9365 4 35.7135 3.4873 17.7367 2.81673 20.5762 -11.5045 -9366 6 14.9588 39.9585 36.8943 -2.86001 -28.3727 24.0409 -9367 4 15.4545 39.4909 36.2335 10.0689 -8.68258 -13.459 -9368 4 15.0094 40.8569 36.655 2.72867 44.443 -9.08423 -9369 6 18.3115 32.3916 11.4639 8.59274 12.4423 14.7113 -9370 4 18.6438 32.5881 12.3772 -9.2478 -5.5834 -23.9484 -9371 4 17.8762 33.212 11.1576 6.35145 -13.5457 0.164794 -9372 6 14.605 10.3819 4.99774 5.57597 -6.68493 12.6773 -9373 4 13.677 10.4388 4.75284 -6.10435 1.24571 -3.75468 -9374 4 14.6185 10.047 5.91478 4.2493 4.0336 -10.9734 -9375 6 2.02851 14.3408 39.1627 -4.03313 12.5981 -1.48522 -9376 4 2.74992 15.009 39.2086 -14.5088 -8.45155 5.07373 -9377 4 1.21458 14.679 39.6124 19.1623 -3.42757 -8.41789 -9378 6 7.58709 14.1522 32.4651 10.4977 19.6861 -0.504887 -9379 4 6.93593 13.6605 32.9674 -3.57672 2.30039 3.8359 -9380 4 7.5987 15.0834 32.797 -1.90079 -22.9019 -5.87851 -9381 6 6.15309 23.123 37.664 -26.7168 -14.8188 -11.2926 -9382 4 6.52639 23.9838 37.7378 17.5333 20.6862 9.20416 -9383 4 5.45539 23.2608 36.9958 8.40974 -10.7335 8.81374 -9384 6 37.3009 22.5422 4.44282 21.6187 66.9857 0.670839 -9385 4 36.5208 22.1217 4.15693 -30.5217 -23.5005 -12.8181 -9386 4 37.1232 23.5227 4.23696 10.5274 -41.8214 11.62 -9387 6 47.1349 31.0113 5.88613 -14.3653 5.64202 -58.02 -9388 4 46.9542 30.9019 6.7933 -9.29323 -2.10558 39.1512 -9389 4 46.2627 31.2059 5.44524 20.5013 -7.22248 10.5418 -9390 6 54.8094 25.5909 34.9286 -5.37395 41.5808 12.672 -9391 4 54.0266 25.5089 35.4943 -0.981006 -11.4098 -6.26775 -9392 4 0.0616925 26.543 35.1263 -1.5494 -32.4448 -11.2369 -9393 6 37.1551 2.08197 4.79239 -12.5712 23.0197 -22.5278 -9394 4 36.5844 2.86136 4.61445 9.59981 -14.8952 -2.62483 -9395 4 37.0798 1.96202 5.72873 2.5296 -7.23911 19.6989 -9396 6 22.5239 28.6012 8.91155 -7.98869 19.6075 21.4366 -9397 4 22.8946 28.4124 9.79991 -0.853296 -5.89568 -17.4096 -9398 4 22.801 27.9767 8.25343 10.1708 -14.6558 -3.7409 -9399 6 8.64208 27.1509 24.5664 -38.2161 25.5543 4.78276 -9400 4 7.71753 26.8887 24.5582 -5.16372 11.0804 -0.386298 -9401 4 9.04357 26.3309 24.4724 40.7169 -47.477 -5.23592 -9402 6 1.14997 23.727 2.4309 6.46058 8.65979 -14.8341 -9403 4 1.18232 23.9936 1.48373 -6.63581 -4.99587 16.5657 -9404 4 0.310199 23.2733 2.54924 -0.981545 -0.950126 -1.89037 -9405 6 54.3702 30.2259 27.0243 -0.035121 6.58363 -4.50453 -9406 4 54.2615 29.4654 26.4339 1.23903 8.74071 -4.24792 -9407 4 54.6064 30.9974 26.4582 -3.83852 -12.4126 5.30421 -9408 6 0.386829 8.42023 23.9938 5.00922 -16.8445 -6.80376 -9409 4 1.36083 8.4508 24.0758 -8.17173 1.21512 3.08891 -9410 4 54.9524 8.88826 24.7258 9.13745 3.54566 6.13736 -9411 6 16.8971 28.5839 33.3722 23.8511 -30.9569 -4.46587 -9412 4 17.442 28.7831 34.1436 -6.82268 9.96305 3.46007 -9413 4 17.4403 27.8723 32.949 -23.4552 19.8179 6.40974 -9414 6 33.6969 30.8931 0.141175 14.1795 0.777253 -0.635822 -9415 4 34.6278 30.5945 0.162696 -6.8513 6.78484 1.91826 -9416 4 33.3211 30.3583 41.3463 -2.66034 -4.05802 -0.0970656 -9417 6 16.2525 21.5202 34.1552 3.2099 -15.0674 -0.387853 -9418 4 16.0099 20.7546 33.5903 4.90739 13.2878 5.87792 -9419 4 16.6977 21.1376 34.9376 -8.96682 7.2262 -10.6242 -9420 6 0.22977 17.7868 35.7492 -9.57638 -14.7124 1.37696 -9421 4 54.2434 17.9569 35.6827 28.6901 -4.22084 5.11773 -9422 4 0.351694 16.93 36.209 -4.1051 13.1178 -5.65765 -9423 6 16.8289 12.2962 0.019427 11.8958 12.8939 11.6481 -9424 4 17.3016 12.8498 0.703368 -12.3262 -21.137 -14.7379 -9425 4 16.4403 11.4936 0.411486 1.39397 8.07719 2.11333 -9426 6 8.24246 9.54397 36.2629 -25.8472 21.2414 2.40819 -9427 4 7.81464 8.9356 36.8788 1.26461 -2.06425 2.56422 -9428 4 7.48979 10.0869 35.9067 16.4576 -8.29365 1.86334 -9429 6 48.5761 26.718 39.8382 -16.8767 -13.2223 25.9758 -9430 4 48.2189 26.9037 38.9774 0.202946 6.43929 -15.4249 -9431 4 49.4865 26.9849 39.8847 17.129 6.93076 -9.10183 -9432 6 35.4777 1.07865 23.1156 20.3084 9.46551 28.8556 -9433 4 36.0215 1.72656 22.6213 -7.75205 -10.5654 8.45632 -9434 4 35.804 1.12911 24.09 -10.3378 -1.68949 -45.1242 -9435 6 20.2777 30.6326 19.3782 17.168 -16.4055 9.77372 -9436 4 20.2499 31.0311 20.2788 1.56461 -6.55175 -10.0354 -9437 4 20.938 29.881 19.3855 -20.6701 22.3694 2.2449 -9438 6 44.3702 15.9458 1.58361 10.9348 22.193 31.2112 -9439 4 44.4077 15.6379 2.51116 -1.71559 -1.42871 -18.164 -9440 4 44.6431 16.8967 1.66823 -9.97295 -22.8516 -13.6111 -9441 6 53.8845 34.4651 10.6068 -24.0145 7.95167 -19.3224 -9442 4 54.4361 34.2696 11.3314 22.7066 -9.19703 33.7305 -9443 4 54.2985 35.2035 10.1555 0.2437 -1.83103 1.50375 -9444 6 46.1364 32.8471 33.519 4.96533 -12.2334 2.48444 -9445 4 45.9404 33.6629 33.0556 -3.66306 8.73713 -2.86335 -9446 4 47.0477 32.6179 33.2654 -4.26196 1.19291 1.09329 -9447 6 42.1324 21.9098 24.2239 34.4777 -24.9191 34.4505 -9448 4 43.0412 21.5159 24.3646 -28.4667 14.3091 -11.1056 -9449 4 41.7437 21.6811 25.0949 -3.80951 9.2794 -19.6729 -9450 6 8.14185 3.89847 11.6387 2.30661 -15.3192 6.95264 -9451 4 7.35197 4.1174 12.1322 -8.99547 12.8437 -2.29886 -9452 4 8.35392 3.05748 12.0535 10.9023 -1.5691 -3.31016 -9453 6 19.6413 41.6808 9.8267 1.07442 6.29255 0.337359 -9454 4 18.9204 41.094 9.57509 0.414049 2.67892 1.92063 -9455 4 19.352 0.205183 10.6506 0.427822 -12.2572 -10.0953 -9456 6 42.3157 8.41085 31.6785 13.3628 11.5473 -7.23952 -9457 4 41.3969 8.42848 31.9417 -9.73605 -1.80426 0.915182 -9458 4 42.5534 9.35818 31.5624 -0.333442 -16.319 1.99913 -9459 6 26.911 16.154 25.3637 -0.10907 13.2502 -20.6653 -9460 4 26.7939 15.8861 24.4207 -0.565005 2.37017 21.4763 -9461 4 26.6835 15.4121 25.9182 -3.52016 -12.4926 6.14171 -9462 6 48.2345 6.48613 12.6212 -1.55264 -8.09911 -9.8466 -9463 4 48.9652 6.31914 12.0011 -5.93235 3.28214 2.19301 -9464 4 47.4516 6.10442 12.1764 7.36669 2.93589 5.65527 -9465 6 53.4556 41.5274 30.6561 0.928349 -3.66285 -10.4005 -9466 4 53.9738 41.8466 29.9077 -1.68735 -3.84443 -4.80087 -9467 4 53.7246 0.16796 31.3785 5.2081 5.34012 15.7103 -9468 6 47.0719 22.4215 31.8177 3.79963 28.0651 -15.4962 -9469 4 47.8542 22.5824 31.2379 -15.4047 -7.22606 14.7582 -9470 4 46.5391 23.2393 31.6689 5.43499 -22.2824 10.2038 -9471 6 19.5241 5.44646 15.2431 57.7261 9.00726 -25.1025 -9472 4 19.973 4.5781 15.2547 -6.4602 7.66804 1.10752 -9473 4 18.6769 5.33307 15.596 -47.9766 -8.78418 19.1468 -9474 6 14.6808 30.2445 33.392 16.954 11.9814 -17.0239 -9475 4 15.1668 30.8865 32.8123 -10.4914 -16.0898 10.6301 -9476 4 15.2553 29.4559 33.3904 -4.22445 9.80292 -0.52553 -9477 6 28.4427 24.2289 10.4187 -0.774793 -27.6212 -36.8967 -9478 4 29.277 24.4414 10.8128 10.21 14.4589 20.8069 -9479 4 27.7162 24.5027 10.9517 -9.91177 12.6254 22.5109 -9480 6 5.25429 14.4357 24.4952 18.8694 8.38265 -3.5804 -9481 4 4.38598 14.1455 24.6681 -43.369 -9.18674 12.4123 -9482 4 5.45154 13.9758 23.6794 9.52503 -2.95522 -10.1363 -9483 6 26.3476 19.2988 19.1857 11.4015 -18.2951 -12.5804 -9484 4 26.5417 20.1869 19.4853 3.52858 10.6793 1.31948 -9485 4 27.146 18.9308 18.7141 -21.2465 13.7562 17.259 -9486 6 28.5834 7.44603 13.1845 8.68409 29.8386 11.3246 -9487 4 28.3961 6.55455 12.9442 -2.45324 -19.0833 -9.20205 -9488 4 29.0571 7.89665 12.4686 -5.14786 -6.54739 -1.73865 -9489 6 5.35742 27.1473 37.0464 13.0843 -4.728 13.8292 -9490 4 6.09472 26.8663 37.6487 -17.7636 2.66278 -18.049 -9491 4 5.49884 28.0724 36.7882 1.93418 -3.90879 0.386893 -9492 6 53.1466 13.4128 16.1104 33.6732 -23.607 0.886679 -9493 4 54.0532 13.0537 15.8959 -24.4904 18.1541 2.55443 -9494 4 52.6056 12.6236 16.2807 -0.490038 10.6025 -2.0621 -9495 6 45.4595 1.03561 24.6152 0.883869 7.22473 8.82703 -9496 4 44.8005 0.912307 23.9218 -0.0838502 -1.3445 -1.23214 -9497 4 44.9845 0.757767 25.4168 6.19386 0.932014 -5.94613 -9498 6 50.1542 2.38642 13.9319 -2.4774 12.931 -1.3926 -9499 4 50.7815 2.76975 13.3044 0.014285 -4.08681 1.38242 -9500 4 49.5062 3.09016 14.0651 -1.63783 -0.639647 1.83323 -9501 6 19.5885 31.0175 39.1657 -10.9837 -21.6636 -18.6241 -9502 4 19.8079 30.3148 38.4832 -5.60324 21.7545 20.6111 -9503 4 18.6148 30.9453 39.3442 26.0441 2.6939 -5.02925 -9504 6 19.2491 14.7106 10.8907 20.9533 -11.5465 -13.087 -9505 4 20.0062 14.1954 10.4207 -44.2836 18.7066 28.5885 -9506 4 18.7045 14.0688 11.3882 14.1221 2.37282 -8.47947 -9507 6 4.44986 39.5549 20.1348 -7.46971 20.8744 22.4052 -9508 4 3.99116 40.4291 20.2667 12.3042 -22.0468 -4.08326 -9509 4 4.78876 39.261 21.0122 -11.398 5.88582 -21.7205 -9510 6 29.0264 13.3645 23.891 3.80322 20.0192 21.3715 -9511 4 28.7263 12.4558 23.8574 1.87437 -3.97007 -2.19356 -9512 4 28.9189 13.5991 24.8488 7.01015 0.856522 -27.3099 -9513 6 17.0674 2.76528 17.6511 13.6679 -9.88609 -24.0062 -9514 4 16.9089 3.43106 16.9566 -0.337692 -4.66999 2.92783 -9515 4 17.7694 2.16287 17.2836 -16.7881 13.7863 9.44417 -9516 6 43.472 18.0456 17.7207 2.90116 -6.00314 -10.3001 -9517 4 43.5328 17.0661 17.6262 0.602958 19.7978 9.46789 -9518 4 43.5843 18.2505 18.6627 0.176297 -8.32564 -1.3476 -9519 6 25.7838 40.7303 1.24723 -3.64329 26.5644 -28.0564 -9520 4 26.2198 41.3001 1.88369 1.46132 -2.86659 8.1156 -9521 4 25.5777 41.3986 0.532216 -2.57635 -28.6607 13.7824 -9522 6 0.458758 22.8928 6.22327 -2.28892 -3.37321 -2.62932 -9523 4 0.911995 22.0955 5.88137 -3.49653 6.37629 4.11618 -9524 4 1.15027 23.4262 6.63616 1.38998 -0.611711 -3.15133 -9525 6 26.2502 35.0072 18.629 11.2346 5.37396 -16.6635 -9526 4 25.9102 35.926 18.5821 -1.77201 -16.2127 4.61622 -9527 4 25.7094 34.5197 19.2578 -0.594129 4.22999 1.61862 -9528 6 16.1509 31.8837 7.54876 40.1408 -29.5169 -1.86921 -9529 4 16.9528 31.2446 7.38162 -38.5191 36.6879 6.5811 -9530 4 16.2422 32.6162 6.9246 8.25996 -4.45471 -3.71716 -9531 6 22.9569 16.8424 28.5503 -18.0144 15.9011 -12.9281 -9532 4 23.0242 16.0615 27.9964 2.65193 -8.47258 -0.731728 -9533 4 22.0914 17.2685 28.2981 23.9965 -14.5366 15.8079 -9534 6 48.817 29.3453 32.1483 10.2159 -3.67765 25.2301 -9535 4 47.913 29.23 31.8533 -10.4354 1.38436 -5.08298 -9536 4 48.8482 28.9579 33.0615 0.343667 8.53482 -20.1614 -9537 6 13.1275 24.857 5.54597 -15.7655 12.0094 -10.6158 -9538 4 12.8967 24.1126 4.95892 -3.19147 7.26676 2.83523 -9539 4 12.4206 25.5605 5.45199 17.9822 -22.1189 1.55356 -9540 6 10.967 20.7149 15.8389 3.49035 -8.57129 -4.90872 -9541 4 10.8232 20.5385 14.8814 6.84933 2.21154 19.4522 -9542 4 11.8211 20.2878 16.0966 -18.2767 7.30584 -13.8769 -9543 6 13.8574 18.376 6.9425 -18.5688 18.5302 -26.9748 -9544 4 14.0551 19.3329 6.99178 3.58444 -10.9562 5.12073 -9545 4 14.2751 17.8929 7.64202 12.8225 -6.30863 19.0643 -9546 6 13.8485 12.9413 30.6405 -7.33075 -24.1801 -9.47477 -9547 4 13.9233 12.3923 29.8469 14.5901 9.31788 -1.12157 -9548 4 13.0284 12.552 30.9634 -3.13873 11.8242 15.1361 -9549 6 17.1199 6.33729 31.2705 58.4108 60.4292 21.9502 -9550 4 16.7347 7.19592 31.0485 -2.55536 -2.82538 -1.05014 -9551 4 16.4932 5.72664 31.0455 -61.4006 -55.6776 -22.0804 -9552 6 7.63858 23.4232 20.5528 2.70849 -2.51933 -11.6338 -9553 4 7.34936 23.0623 19.6936 2.42656 1.66026 8.60009 -9554 4 8.06294 24.2698 20.3247 -2.54411 -7.58863 2.30144 -9555 6 15.6012 36.6828 25.6308 12.0382 0.865576 2.42327 -9556 4 16.546 36.4866 25.8589 -19.7129 13.5166 -7.57965 -9557 4 15.5566 37.5233 25.1245 15.7859 -9.47529 6.9914 -9558 6 0.738662 10.4099 22.1708 -26.6289 -22.4058 -14.7131 -9559 4 0.0268398 10.3645 21.4686 20.8647 0.21224 20.3485 -9560 4 0.555589 9.63254 22.7491 3.84168 18.0907 -12.5939 -9561 6 33.5034 17.3959 33.5951 21.201 30.6084 -13.4811 -9562 4 33.5895 18.3893 33.3705 0.776259 -45.1899 5.95193 -9563 4 34.1847 16.8766 33.1005 -9.04546 14.4589 8.38708 -9564 6 21.6622 19.013 20.7578 31.9274 -22.1518 -4.15649 -9565 4 22.4096 19.6032 20.9777 -11.5486 -3.71871 -1.82252 -9566 4 22.1307 18.1402 20.6082 -20.9219 25.304 3.1187 -9567 6 41.7583 19.992 16.8792 -6.68772 4.02339 -8.69865 -9568 4 42.2438 19.1637 16.9575 3.64207 -5.49479 0.617993 -9569 4 41.579 20.1273 15.9247 3.71595 -2.33609 11.0843 -9570 6 12.0355 14.9654 17.6922 -21.5841 1.26502 -18.8824 -9571 4 11.2182 14.5976 17.276 14.8021 5.3277 12.4216 -9572 4 12.4319 14.255 18.1907 -0.352973 -10.2116 7.98966 -9573 6 23.0172 11.4191 40.7206 -10.7217 24.0381 44.0704 -9574 4 22.9528 12.3236 41.1181 -0.480688 -24.3492 -4.33206 -9575 4 23.3445 11.5906 39.8675 15.3819 0.516123 -37.823 -9576 6 21.0055 28.3299 24.5595 -23.1154 26.0001 -7.02903 -9577 4 20.2855 28.1767 25.1713 -12.8069 16.7504 -3.2857 -9578 4 21.5564 27.6405 24.838 35.6802 -30.9994 4.41974 -9579 6 19.406 13.705 31.9364 14.5236 -8.57279 10.3452 -9580 4 18.7521 13.9469 31.2876 -5.81883 0.611034 -8.78432 -9581 4 18.9142 13.6788 32.7621 -0.186305 1.04404 6.29106 -9582 6 21.5918 2.86134 24.7058 -12.3779 12.1824 -8.79066 -9583 4 21.7274 3.16074 23.7816 9.4572 -7.89437 13.7797 -9584 4 22.4025 2.45534 25.0386 5.22934 2.42127 -4.70961 -9585 6 11.3487 29.9838 18.827 10.5554 -3.16976 4.47537 -9586 4 10.5352 30.5203 18.751 15.2364 -2.61973 2.60085 -9587 4 12.0043 30.4181 19.4217 -22.0541 -6.82347 -15.9561 -9588 6 14.6417 22.3529 8.3686 35.183 35.1516 7.4005 -9589 4 14.0314 23.0645 8.61446 -9.87113 -8.59651 0.991548 -9590 4 15.5117 22.8693 8.31218 -34.203 -30.7208 1.23805 -9591 6 43.9533 23.6664 17.2647 -9.15762 31.6597 -10.4885 -9592 4 44.7744 23.2846 16.9678 11.7125 -13.1472 -3.62648 -9593 4 43.5104 22.9908 17.7726 1.91474 -8.51607 6.21827 -9594 6 28.003 25.5014 27.4986 6.23457 -29.1533 -5.23677 -9595 4 27.4849 26.2827 27.5489 -17.6876 27.9136 1.36856 -9596 4 28.906 25.8001 27.3829 8.21911 6.89622 0.0845564 -9597 6 19.1046 26.8047 33.1413 12.2661 11.24 -48.0243 -9598 4 19.0365 26.4782 32.1917 1.11076 11.999 35.7369 -9599 4 19.4769 27.7251 33.0545 -9.7287 -23.6705 8.34301 -9600 6 6.37289 19.3428 5.67363 -3.21133 -16.2285 8.07537 -9601 4 6.7336 20.019 5.09886 3.22925 8.22387 -6.14542 -9602 4 5.58923 19.7346 6.08082 -0.796808 3.74051 2.3056 -9603 6 37.4835 28.3972 9.67963 -16.8252 8.64443 -22.9196 -9604 4 37.8384 28.0931 10.5154 1.79485 -10.7977 1.13655 -9605 4 37.3056 27.6421 9.07717 9.05958 5.47813 21.4583 -9606 6 17.6994 27.086 11.7957 -23.9049 -9.71644 -0.114793 -9607 4 16.9894 26.5877 11.2784 19.3807 18.9653 23.0761 -9608 4 17.3772 27.2467 12.7205 1.32974 -4.86863 -22.184 -9609 6 12.8804 1.95044 24.1635 -16.9081 23.6463 -41.3936 -9610 4 12.0123 2.42693 23.9788 24.6345 -20.1638 18.4271 -9611 4 12.9602 1.63912 25.0531 -11.2641 -4.9093 21.6908 -9612 6 27.8486 37.1249 33.3037 14.5525 0.843809 -12.8082 -9613 4 27.8306 37.7566 32.5563 -0.261378 -9.54721 11.1245 -9614 4 28.4641 36.389 33.0416 -14.495 18.5162 4.94281 -9615 6 18.6769 12.3657 6.31954 -0.243732 -29.9473 12.6257 -9616 4 18.5317 11.3932 6.23771 0.963018 17.4883 6.62231 -9617 4 18.5535 12.6707 5.42951 -3.51714 10.9469 -19.8301 -9618 6 10.1845 29.3127 24.783 -1.36331 5.89889 -4.08473 -9619 4 10.7465 29.1085 25.5662 -10.353 -5.60455 -9.55427 -9620 4 9.5047 28.6152 24.6271 17.6265 9.93184 12.3415 -9621 6 7.25219 3.30976 16.2618 16.5712 6.01323 38.0962 -9622 4 7.85224 3.92676 16.743 -7.28275 2.21025 -21.7569 -9623 4 7.07626 2.67339 16.9792 -0.839688 -3.96601 -21.0406 -9624 6 32.2032 37.556 1.10106 -1.45173 2.30566 -1.67736 -9625 4 31.7319 37.0242 1.72254 -12.3544 -30.6614 1.12887 -9626 4 32.1826 38.3533 1.61216 9.84976 31.1212 -1.90535 -9627 6 10.4132 10.1536 6.41547 2.6172 -5.66149 -5.23088 -9628 4 9.51094 10.4988 6.43252 -1.43241 7.72691 5.99088 -9629 4 10.888 10.4598 7.20926 -10.4429 3.02901 -4.20627 -9630 6 16.1922 23.2473 37.3836 13.4596 17.9231 -6.20094 -9631 4 16.4628 23.5362 38.2769 -1.8179 -2.41291 -6.91424 -9632 4 16.622 23.8878 36.7607 -9.68345 -13.0364 13.8052 -9633 6 24.0933 14.3373 36.5438 -0.810617 7.47513 6.008 -9634 4 25.0172 14.0983 36.6068 9.64822 -3.29568 0.232999 -9635 4 23.7283 14.0715 37.4031 -3.57511 2.15125 -3.19243 -9636 6 27.4694 18.5535 28.7878 -22.2405 -8.90967 9.68842 -9637 4 27.2463 18.155 29.6474 7.14424 4.94771 -10.1046 -9638 4 26.6163 18.5328 28.3045 10.7583 2.44378 -0.411902 -9639 6 51.5617 10.4928 1.56364 -46.044 -5.31617 -17.9438 -9640 4 50.711 10.1131 1.91707 23.1705 13.8427 -10.0979 -9641 4 52.2015 10.4284 2.24991 18.8641 -3.04547 25.194 -9642 6 31.1163 39.6073 27.5052 16.7753 -4.77526 -29.689 -9643 4 30.6203 39.2762 28.2489 -5.6675 10.9492 15.0474 -9644 4 31.3773 40.5466 27.6182 -8.67746 -20.5696 10.3555 -9645 6 6.90447 35.9666 14.3264 -30.1691 -4.34312 14.222 -9646 4 7.61578 36.3042 13.808 21.2575 5.14969 -9.00238 -9647 4 7.11482 35.0613 14.5906 3.01946 -0.973686 -2.74545 -9648 6 45.5514 7.57029 29.1841 -25.615 -5.69379 -2.02895 -9649 4 44.9198 7.51228 28.4263 15.6429 0.393509 16.1679 -9650 4 45.0848 7.11279 29.9186 7.09759 5.05324 -8.24334 -9651 6 31.3626 20.5603 31.6216 46.5235 7.85379 -13.5612 -9652 4 31.9622 21.3332 31.7077 -20.5518 -6.12612 6.97271 -9653 4 31.9328 19.9839 31.0823 -17.3109 -3.90007 7.28444 -9654 6 43.0286 31.1606 10.377 -16.6603 7.93207 28.9623 -9655 4 42.0878 30.8529 10.4887 24.119 8.07098 -2.29185 -9656 4 43.3099 31.4942 11.272 -6.72297 -13.7816 -28.1326 -9657 6 50.925 25.5606 12.6461 -27.6852 -6.08767 20.8539 -9658 4 50.917 26.3683 12.1731 -8.31821 35.0391 -16.2433 -9659 4 51.8024 25.2628 12.5325 34.7451 -18.8429 0.848912 -9660 6 29.3305 2.97987 3.64738 17.2649 -36.5424 -5.61333 -9661 4 29.6156 3.84373 3.86529 8.03017 35.8359 9.57326 -9662 4 28.4158 3.03535 3.41816 -23.9953 6.75187 -10.8335 -9663 6 53.9216 32.1051 20.3724 -11.2223 -0.478332 -4.16652 -9664 4 54.8523 32.157 20.1701 8.27859 1.2318 1.83366 -9665 4 53.5473 31.7256 19.5583 -4.88871 3.83013 8.11791 -9666 6 41.7036 29.5569 6.48267 17.2638 16.7804 -5.64052 -9667 4 40.7698 29.5903 6.27928 -11.16 5.83742 -3.44443 -9668 4 42.1548 30.305 5.99503 -16.5783 -19.3567 12.2041 -9669 6 37.8345 24.5719 39.3019 -13.0469 -9.65298 -3.86921 -9670 4 37.225 24.2046 38.6488 4.5791 4.74434 1.49749 -9671 4 37.4276 24.3068 40.1372 5.55374 4.45167 1.85829 -9672 6 46.5621 27.5658 23.2944 -23.9279 -33.0439 -11.1022 -9673 4 46.4387 27.4786 24.2739 -2.64996 -4.90603 -22.3791 -9674 4 45.938 26.8598 22.8442 32.7587 35.3455 32.269 -9675 6 9.23408 27.197 8.34767 -28.7607 6.82988 18.9345 -9676 4 8.89078 27.6282 9.16421 9.10203 -8.06063 -16.3167 -9677 4 10.1694 27.1106 8.44975 24.8451 0.83524 4.07321 -9678 6 36.0586 34.168 13.9947 0.546429 -20.5208 -0.995849 -9679 4 35.8317 33.2019 13.9926 1.47243 21.3574 0.844463 -9680 4 36.7518 34.2454 13.3214 -1.12661 -0.38848 2.20278 -9681 6 51.6812 14.492 12.3108 14.2062 7.57429 -10.7818 -9682 4 52.2015 14.4126 11.4771 -7.23407 7.45688 18.698 -9683 4 51.902 15.34 12.7416 -3.60656 -14.3916 -9.37264 -9684 6 15.248 19.6366 32.4109 27.4357 -16.6396 -20.9158 -9685 4 15.2931 19.2358 31.5053 -3.54534 7.22564 18.4797 -9686 4 14.3328 19.7639 32.5881 -28.0981 2.1384 2.91772 -9687 6 27.6849 24.6479 38.3573 2.41004 -14.3506 -18.7558 -9688 4 27.9256 25.2107 39.0738 -0.349992 17.1553 25.2623 -9689 4 28.4455 24.6938 37.7731 2.45273 -2.47407 -6.18841 -9690 6 37.5344 9.26205 13.6222 2.62805 -1.42602 2.92011 -9691 4 37.9029 8.73293 14.3466 0.897712 0.834078 0.0180659 -9692 4 37.323 10.115 14.0326 -0.799981 -1.44542 -1.10758 -9693 6 20.9013 33.2307 26.2512 6.46074 3.54373 3.40895 -9694 4 21.2661 33.4546 27.1222 -3.70394 5.03607 -5.2507 -9695 4 21.0534 32.294 26.1755 2.06129 -12.757 -1.69162 -9696 6 6.58179 13.9421 35.2385 -0.161437 -23.8226 2.06013 -9697 4 6.46846 12.9778 35.1898 -10.847 5.63462 -0.921172 -9698 4 7.53649 14.0007 35.2781 8.40152 11.229 1.63712 -9699 6 10.0736 7.47184 6.87074 6.29005 1.76204 -5.26249 -9700 4 9.16789 7.18556 6.66525 -0.124912 3.45645 -0.864518 -9701 4 10.1825 8.41968 6.63706 -5.90018 -13.0861 3.35766 -9702 6 31.1989 5.96627 11.4256 47.5137 28.7614 23.6553 -9703 4 31.4466 6.13876 12.388 -20.2952 -9.94335 -33.1747 -9704 4 32.0308 6.26994 10.9806 -22.1211 -12.2896 5.82222 -9705 6 12.1387 3.84993 35.2935 2.49551 -0.304387 23.4243 -9706 4 12.8187 4.19174 34.7257 10.4227 4.50872 -14.559 -9707 4 12.5185 4.00559 36.1769 -9.60543 -1.42105 -7.76228 -9708 6 5.33665 6.07757 27.6447 8.69228 -34.5823 40.5077 -9709 4 5.10952 6.83187 28.1919 -5.14709 12.9851 -0.252954 -9710 4 5.24124 6.31071 26.7545 -7.00092 22.4827 -45.3835 -9711 6 13.1372 33.5675 1.68451 12.1014 31.5323 -4.45098 -9712 4 12.5865 33.1501 1.03303 -8.81838 -7.47149 -8.20936 -9713 4 13.3352 34.4765 1.32576 -5.5291 -24.3721 14.4697 -9714 6 44.6567 10.4099 29.0319 -12.4525 3.56979 -21.9228 -9715 4 44.5737 9.45178 29.0051 9.95574 -3.72472 2.79876 -9716 4 44.0317 10.7133 28.332 10.7873 2.60441 13.9487 -9717 6 9.14585 24.5947 6.38022 15.9839 26.3438 -7.73853 -9718 4 8.92734 24.382 5.47582 -9.1117 -9.61509 -8.5024 -9719 4 9.72625 25.3768 6.21639 -5.50996 -10.1894 15.5503 -9720 6 52.5653 27.2618 21.6392 -6.48047 6.16108 13.4347 -9721 4 52.5564 26.3196 21.8908 4.78081 5.6644 -14.1528 -9722 4 52.8195 27.3969 20.7225 3.24319 -11.7343 -6.41363 -9723 6 7.29679 16.9603 33.544 -1.27463 2.76823 -11.9762 -9724 4 7.39152 17.7215 32.9493 2.03275 -0.910573 2.88066 -9725 4 6.37085 16.7082 33.4809 -4.66481 0.778096 -0.770576 -9726 6 43.9289 25.2227 7.97871 -4.96366 -10.0233 8.38699 -9727 4 43.2519 24.7308 8.49213 12.2574 5.67032 -8.3389 -9728 4 43.4276 25.9018 7.51862 -3.04483 5.5605 -3.23664 -9729 6 2.07953 27.1233 13.6028 0.0104954 7.16496 -8.77242 -9730 4 2.15896 26.2371 13.9627 -2.1358 -7.6126 6.04882 -9731 4 2.6502 27.1018 12.8141 -2.23666 2.89631 3.72058 -9732 6 37.3141 18.284 2.18477 -5.94753 -1.23785 7.60386 -9733 4 37.4961 17.5691 1.55591 -3.17432 -0.490531 -1.7774 -9734 4 36.7255 18.8979 1.7415 -3.03937 1.4219 -5.67571 -9735 6 25.0022 10.0655 0.429871 -30.1443 -7.37242 -0.593153 -9736 4 24.272 10.366 41.7528 14.2211 1.75124 5.05026 -9737 4 24.5705 9.40237 1.00583 14.7283 12.1051 -6.86513 diff --git a/examples/amoeba/in.water_box.amoeba.test b/examples/amoeba/in.water_box.amoeba.test index 1ee4fc0018..ca63996264 100644 --- a/examples/amoeba/in.water_box.amoeba.test +++ b/examples/amoeba/in.water_box.amoeba.test @@ -11,9 +11,8 @@ dihedral_style none # per-atom properties required by AMOEBA or HIPPO fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom & - i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes -fix extra2 all property/atom i_polaxe +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 # read data file diff --git a/examples/amoeba/in.water_box.hippo.test b/examples/amoeba/in.water_box.hippo.test index 2c414017f6..ec1cc1cc78 100644 --- a/examples/amoeba/in.water_box.hippo.test +++ b/examples/amoeba/in.water_box.hippo.test @@ -11,9 +11,8 @@ dihedral_style none # per-atom properties required by AMOEBA or HIPPO fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom & - i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes -fix extra2 all property/atom i_polaxe +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 # read data file diff --git a/examples/amoeba/in.water_dimer.amoeba.test b/examples/amoeba/in.water_dimer.amoeba.test index 66fa60e351..6e388e9951 100644 --- a/examples/amoeba/in.water_dimer.amoeba.test +++ b/examples/amoeba/in.water_dimer.amoeba.test @@ -11,9 +11,8 @@ dihedral_style none # per-atom properties required by AMOEBA or HIPPO fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom & - i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes -fix extra2 all property/atom i_polaxe +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 # read data file diff --git a/examples/amoeba/in.water_dimer.hippo.test b/examples/amoeba/in.water_dimer.hippo.test index 5ed920ffda..15a7327d5b 100644 --- a/examples/amoeba/in.water_dimer.hippo.test +++ b/examples/amoeba/in.water_dimer.hippo.test @@ -11,9 +11,8 @@ dihedral_style none # per-atom properties required by AMOEBA or HIPPO fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom & - i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes -fix extra2 all property/atom i_polaxe +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 # read data file diff --git a/examples/amoeba/in.water_hexamer.amoeba.test b/examples/amoeba/in.water_hexamer.amoeba.test index bc14833778..b96ec3974a 100644 --- a/examples/amoeba/in.water_hexamer.amoeba.test +++ b/examples/amoeba/in.water_hexamer.amoeba.test @@ -11,9 +11,8 @@ dihedral_style none # per-atom properties required by AMOEBA or HIPPO fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom & - i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes -fix extra2 all property/atom i_polaxe +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 # read data file diff --git a/examples/amoeba/in.water_hexamer.hippo.test b/examples/amoeba/in.water_hexamer.hippo.test index 28a06dcefe..6e4b40ffa5 100644 --- a/examples/amoeba/in.water_hexamer.hippo.test +++ b/examples/amoeba/in.water_hexamer.hippo.test @@ -11,9 +11,8 @@ dihedral_style none # per-atom properties required by AMOEBA or HIPPO fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom & - i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes -fix extra2 all property/atom i_polaxe +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 # read data file diff --git a/examples/amoeba/log.ubi.1.test b/examples/amoeba/log.ubi.1.test index f931a6aeb3..f0c387e50b 100644 --- a/examples/amoeba/log.ubi.1.test +++ b/examples/amoeba/log.ubi.1.test @@ -15,15 +15,16 @@ improper_style amoeba # per-atom properties required by AMOEBA or HIPPO fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 + fix pit all amoeba/pitorsion fix_modify pit energy yes fix bit all amoeba/bitorsion bitorsion.ubiquitin.data fix_modify bit energy yes -fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes -fix extra2 all property/atom i_polaxe +# read data file -#read_data data.ubiquitin fix amtype NULL "Tinker Types" read_data data.ubiquitin fix amtype NULL "Tinker Types" fix pit "pitorsion types" "PiTorsion Coeffs" fix pit pitorsions PiTorsions fix bit bitorsions BiTorsions Reading data file ... orthogonal box = (0 0 0) to (54.99 41.91 41.91) @@ -54,7 +55,7 @@ Finding 1-2 1-3 1-4 neighbors ... 19 = max # of 1-4 neighbors 21 = max # of special neighbors special bonds CPU = 0.004 seconds - read_data CPU = 0.076 seconds + read_data CPU = 0.082 seconds pair_style amoeba pair_coeff * * amoeba_ubiquitin.prm amoeba_ubiquitin.key @@ -109,7 +110,7 @@ Neighbor list info ... stencil: half/bin/3d bin: standard AMOEBA/HIPPO group count: 3196 -Per MPI rank memory allocation (min/avg/max) = 98.55 | 98.55 | 98.55 Mbytes +Per MPI rank memory allocation (min/avg/max) = 260.4 | 260.4 | 260.4 Mbytes Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] 0 0 -35338.057 2856.5938 1955.5431 224.37609 65.00809 5101.5211 -30247.585 -6336.5196 -5795.4272 -6329.8149 -6884.3167 349.52657 77.164877 652.41925 1 29.61379 -35356.153 2037.3541 1840.7883 223.90217 64.293945 4166.3385 -30341.522 -6486.773 -6452.8463 -6841.5982 -7386.1106 311.38025 120.72605 545.35513 @@ -121,31 +122,30 @@ Per MPI rank memory allocation (min/avg/max) = 98.55 | 98.55 | 98.55 Mbytes 7 137.7204 -36521.444 782.87113 1026.745 212.04289 38.686259 2060.3452 -30479.082 -5987.83 -8386.8104 -7363.188 -7888.261 357.00835 253.66346 32.827786 8 112.66452 -36897.181 1750.0569 1269.152 210.83571 33.742799 3263.7874 -30379.432 -7886.4081 -9703.2601 -9043.015 -9555.2908 490.76046 182.31259 278.727 9 88.237359 -37209.906 2695.1766 1454.55 209.91331 29.503458 4389.1434 -30276.565 -8202.16 -9492.368 -9110.7037 -9639.2288 502.55699 107.82333 443.6705 - -AMEOBA/HIPPO timing info: - Init time: 0.0295323 0.00130007 - Hal time: 7.40889 32.6154 - Mpole time: 2.19209 9.65001 - Induce time: 8.54492 37.6164 - Polar time: 4.5405 19.9882 - Total time: 22.7159 - 10 108.86756 -37474.988 2240.4603 1523.7936 209.10313 26.208515 3999.5656 -30333.279 -8468.4347 -9956.923 -9709.5874 -10224.682 365.98214 95.262991 425.12746 -Loop time of 22.7636 on 1 procs for 10 steps with 9737 atoms +Loop time of 21.791 on 1 procs for 10 steps with 9737 atoms -Performance: 0.038 ns/day, 632.324 hours/ns, 0.439 timesteps/s -98.1% CPU use with 1 MPI tasks x no OpenMP threads +Performance: 0.040 ns/day, 605.307 hours/ns, 0.459 timesteps/s +99.1% CPU use with 1 MPI tasks x no OpenMP threads + +AMEOBA/HIPPO timing breakdown: + Init time: 0.0264311 0.00121566 + Hal time: 7.15654 32.9156 + Mpole time: 2.14232 9.85334 + Induce time: 7.99277 36.7617 + Polar time: 4.42403 20.3477 + Total time: 21.7421 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 22.716 | 22.716 | 22.716 | 0.0 | 99.79 -Bond | 0.015795 | 0.015795 | 0.015795 | 0.0 | 0.07 +Pair | 21.742 | 21.742 | 21.742 | 0.0 | 99.78 +Bond | 0.014806 | 0.014806 | 0.014806 | 0.0 | 0.07 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.003791 | 0.003791 | 0.003791 | 0.0 | 0.02 -Output | 0.024013 | 0.024013 | 0.024013 | 0.0 | 0.11 -Modify | 0.00335 | 0.00335 | 0.00335 | 0.0 | 0.01 -Other | | 0.0006405 | | | 0.00 +Comm | 0.0035774 | 0.0035774 | 0.0035774 | 0.0 | 0.02 +Output | 0.026947 | 0.026947 | 0.026947 | 0.0 | 0.12 +Modify | 0.0028419 | 0.0028419 | 0.0028419 | 0.0 | 0.01 +Other | | 0.0007034 | | | 0.00 Nlocal: 9737 ave 9737 max 9737 min Histogram: 1 0 0 0 0 0 0 0 0 0 @@ -159,4 +159,4 @@ Ave neighs/atom = 579.16155 Ave special neighs/atom = 3.1364897 Neighbor list builds = 0 Dangerous builds = 0 -Total wall time: 0:00:26 +Total wall time: 0:00:24 diff --git a/examples/amoeba/log.ubi.32.test b/examples/amoeba/log.ubi.32.test index bdb97fe194..b0bc4b381e 100644 --- a/examples/amoeba/log.ubi.32.test +++ b/examples/amoeba/log.ubi.32.test @@ -15,15 +15,16 @@ improper_style amoeba # per-atom properties required by AMOEBA or HIPPO fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 + fix pit all amoeba/pitorsion fix_modify pit energy yes fix bit all amoeba/bitorsion bitorsion.ubiquitin.data fix_modify bit energy yes -fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes -fix extra2 all property/atom i_polaxe +# read data file -#read_data data.ubiquitin fix amtype NULL "Tinker Types" read_data data.ubiquitin fix amtype NULL "Tinker Types" fix pit "pitorsion types" "PiTorsion Coeffs" fix pit pitorsions PiTorsions fix bit bitorsions BiTorsions Reading data file ... orthogonal box = (0 0 0) to (54.99 41.91 41.91) @@ -54,7 +55,7 @@ Finding 1-2 1-3 1-4 neighbors ... 19 = max # of 1-4 neighbors 21 = max # of special neighbors special bonds CPU = 0.002 seconds - read_data CPU = 0.120 seconds + read_data CPU = 0.112 seconds pair_style amoeba pair_coeff * * amoeba_ubiquitin.prm amoeba_ubiquitin.key @@ -109,7 +110,7 @@ Neighbor list info ... stencil: half/bin/3d bin: standard AMOEBA/HIPPO group count: 3196 -Per MPI rank memory allocation (min/avg/max) = 26.19 | 26.49 | 27.59 Mbytes +Per MPI rank memory allocation (min/avg/max) = 73.46 | 73.76 | 74.86 Mbytes Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] 0 0 -35338.057 2856.5938 1955.5431 224.37609 65.00809 5101.5211 -30247.585 -6336.5196 -5795.4272 -6329.8149 -6884.3167 349.52657 77.164877 652.41925 1 29.61379 -35356.153 2037.3541 1840.7883 223.90217 64.293945 4166.3385 -30341.522 -6486.773 -6452.8463 -6841.5982 -7386.1106 311.38025 120.72605 545.35513 @@ -121,31 +122,30 @@ Per MPI rank memory allocation (min/avg/max) = 26.19 | 26.49 | 27.59 Mbytes 7 137.7204 -36521.444 782.87113 1026.745 212.04289 38.686259 2060.3452 -30479.082 -5987.83 -8386.8104 -7363.188 -7888.261 357.00835 253.66346 32.827786 8 112.66452 -36897.181 1750.0569 1269.152 210.83571 33.742799 3263.7874 -30379.432 -7886.4081 -9703.2601 -9043.015 -9555.2908 490.76046 182.31259 278.727 9 88.237359 -37209.906 2695.1766 1454.55 209.91331 29.503458 4389.1434 -30276.565 -8202.16 -9492.368 -9110.7037 -9639.2288 502.55699 107.82333 443.6705 - -AMEOBA/HIPPO timing info: - Init time: 0.0255174 0.0162332 - Hal time: 0.273968 17.4289 - Mpole time: 0.202832 12.9035 - Induce time: 0.79876 50.8142 - Polar time: 0.270839 17.2298 - Total time: 1.57192 - 10 108.86756 -37474.988 2240.4603 1523.7936 209.10313 26.208515 3999.5656 -30333.279 -8468.4347 -9956.923 -9709.5874 -10224.682 365.98214 95.262991 425.12746 -Loop time of 1.58782 on 32 procs for 10 steps with 9737 atoms +Loop time of 1.51355 on 32 procs for 10 steps with 9737 atoms -Performance: 0.544 ns/day, 44.106 hours/ns, 6.298 timesteps/s -99.3% CPU use with 32 MPI tasks x no OpenMP threads +Performance: 0.571 ns/day, 42.043 hours/ns, 6.607 timesteps/s +99.5% CPU use with 32 MPI tasks x no OpenMP threads + +AMEOBA/HIPPO timing breakdown: + Init time: 0.0221241 0.0147382 + Hal time: 0.27487 18.3107 + Mpole time: 0.1964 13.0833 + Induce time: 0.743514 49.5298 + Polar time: 0.264231 17.602 + Total time: 1.50114 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 1.5717 | 1.5724 | 1.5732 | 0.0 | 99.03 -Bond | 0.00025512 | 0.00072817 | 0.0025027 | 0.0 | 0.05 +Pair | 1.5006 | 1.5014 | 1.5026 | 0.1 | 99.20 +Bond | 0.00023121 | 0.0006371 | 0.002095 | 0.0 | 0.04 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.008108 | 0.010596 | 0.011659 | 0.9 | 0.67 -Output | 0.0032598 | 0.0035294 | 0.0038605 | 0.2 | 0.22 -Modify | 0.00017743 | 0.00030162 | 0.00054742 | 0.0 | 0.02 -Other | | 0.0002902 | | | 0.02 +Comm | 0.0060146 | 0.008046 | 0.0092638 | 1.0 | 0.53 +Output | 0.0028415 | 0.0030424 | 0.003441 | 0.2 | 0.20 +Modify | 0.00011709 | 0.00019911 | 0.00036104 | 0.0 | 0.01 +Other | | 0.0002509 | | | 0.02 Nlocal: 304.281 ave 326 max 273 min Histogram: 1 1 0 5 2 8 3 6 4 2 @@ -159,4 +159,4 @@ Ave neighs/atom = 579.16155 Ave special neighs/atom = 3.1364897 Neighbor list builds = 0 Dangerous builds = 0 -Total wall time: 0:00:02 +Total wall time: 0:00:01 diff --git a/examples/amoeba/log.water_box.amoeba.1.test b/examples/amoeba/log.water_box.amoeba.1.test index dfdf8d27aa..8f81eaaf42 100644 --- a/examples/amoeba/log.water_box.amoeba.1.test +++ b/examples/amoeba/log.water_box.amoeba.1.test @@ -12,8 +12,8 @@ dihedral_style none # per-atom properties required by AMOEBA or HIPPO fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes -fix extra2 all property/atom i_polaxe +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 # read data file @@ -39,7 +39,7 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of special neighbors special bonds CPU = 0.000 seconds - read_data CPU = 0.010 seconds + read_data CPU = 0.012 seconds # force field @@ -96,7 +96,7 @@ Neighbor list info ... stencil: half/bin/3d bin: standard AMOEBA/HIPPO group count: 216 -Per MPI rank memory allocation (min/avg/max) = 10.9 | 10.9 | 10.9 Mbytes +Per MPI rank memory allocation (min/avg/max) = 58.28 | 58.28 | 58.28 Mbytes Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] 0 0 -2172.0441 166.82637 83.732524 0 0 250.5589 -1921.4852 -6181.7112 -4771.8292 -6955.3278 -6817.9765 -272.19746 3173.3487 2229.6526 10 105.50439 -2373.6865 136.67908 106.86552 0 0 243.54459 -1926.6678 -8441.2174 -10450.318 -9514.124 -9665.625 -301.45304 322.2435 1916.9694 @@ -108,31 +108,30 @@ Per MPI rank memory allocation (min/avg/max) = 10.9 | 10.9 | 10.9 Mbytes 70 166.70629 -2383.4827 76.492455 55.020922 0 0 131.51338 -1930.4622 4743.9587 1916.6786 2839.9241 2670.7568 -169.67855 -187.58379 -2256.4529 80 171.82933 -2388.0347 76.463333 49.138785 0 0 125.60212 -1931.0453 2210.1222 -319.99043 330.98785 -394.25628 -44.858027 252.35533 -1985.0908 90 175.7327 -2423.7974 90.784969 63.725029 0 0 154.51 -1930.3722 -917.58179 -3941.9566 -2568.4278 -3415.3121 196.38051 2366.2885 -263.52434 - -AMEOBA/HIPPO timing info: - Init time: 0.0268067 0.000648832 - Hal time: 0.950781 2.30127 - Mpole time: 2.62623 6.35653 - Induce time: 31.3736 75.9368 - Polar time: 6.33798 15.3405 - Total time: 41.3154 - 100 173.73319 -2422.3616 99.761403 57.29505 0 0 157.05645 -1930.2461 -3586.4169 -5733.9943 -5881.4025 -6235.1905 -230.75166 959.02899 406.2349 -Loop time of 41.3458 on 1 procs for 100 steps with 648 atoms +Loop time of 38.7603 on 1 procs for 100 steps with 648 atoms -Performance: 0.209 ns/day, 114.849 hours/ns, 2.419 timesteps/s +Performance: 0.223 ns/day, 107.668 hours/ns, 2.580 timesteps/s 99.6% CPU use with 1 MPI tasks x no OpenMP threads +AMEOBA/HIPPO timing breakdown: + Init time: 0.0258209 0.000666708 + Hal time: 0.889324 2.29628 + Mpole time: 2.44816 6.32126 + Induce time: 29.4141 75.9487 + Polar time: 5.95145 15.3669 + Total time: 38.7289 + MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 41.316 | 41.316 | 41.316 | 0.0 | 99.93 -Bond | 0.0034989 | 0.0034989 | 0.0034989 | 0.0 | 0.01 -Neigh | 0.0060545 | 0.0060545 | 0.0060545 | 0.0 | 0.01 -Comm | 0.0037812 | 0.0037812 | 0.0037812 | 0.0 | 0.01 -Output | 0.014701 | 0.014701 | 0.014701 | 0.0 | 0.04 -Modify | 0.00098692 | 0.00098692 | 0.00098692 | 0.0 | 0.00 -Other | | 0.001033 | | | 0.00 +Pair | 38.729 | 38.729 | 38.729 | 0.0 | 99.92 +Bond | 0.003226 | 0.003226 | 0.003226 | 0.0 | 0.01 +Neigh | 0.0054679 | 0.0054679 | 0.0054679 | 0.0 | 0.01 +Comm | 0.0036497 | 0.0036497 | 0.0036497 | 0.0 | 0.01 +Output | 0.01663 | 0.01663 | 0.01663 | 0.0 | 0.04 +Modify | 0.00088965 | 0.00088965 | 0.00088965 | 0.0 | 0.00 +Other | | 0.001155 | | | 0.00 Nlocal: 648 ave 648 max 648 min Histogram: 1 0 0 0 0 0 0 0 0 0 @@ -146,4 +145,4 @@ Ave neighs/atom = 152.07253 Ave special neighs/atom = 2 Neighbor list builds = 2 Dangerous builds = 0 -Total wall time: 0:00:42 +Total wall time: 0:00:39 diff --git a/examples/amoeba/log.water_box.amoeba.32.test b/examples/amoeba/log.water_box.amoeba.32.test index 6f74cf5d2d..16a0168dac 100644 --- a/examples/amoeba/log.water_box.amoeba.32.test +++ b/examples/amoeba/log.water_box.amoeba.32.test @@ -12,8 +12,8 @@ dihedral_style none # per-atom properties required by AMOEBA or HIPPO fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes -fix extra2 all property/atom i_polaxe +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 # read data file @@ -39,7 +39,7 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of special neighbors special bonds CPU = 0.002 seconds - read_data CPU = 0.026 seconds + read_data CPU = 0.020 seconds # force field @@ -55,7 +55,7 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of 1-5 neighbors 2 = max # of special neighbors - special bonds CPU = 0.002 seconds + special bonds CPU = 0.001 seconds # thermo output @@ -96,7 +96,7 @@ Neighbor list info ... stencil: half/bin/3d bin: standard AMOEBA/HIPPO group count: 216 -Per MPI rank memory allocation (min/avg/max) = 10.07 | 10.08 | 10.34 Mbytes +Per MPI rank memory allocation (min/avg/max) = 57.47 | 57.48 | 57.74 Mbytes Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] 0 0 -2172.0441 166.82637 83.732524 0 0 250.5589 -1921.4852 -6181.7112 -4771.8292 -6955.3278 -6817.9765 -272.19746 3173.3487 2229.6526 10 105.50439 -2373.6865 136.67908 106.86552 0 0 243.54459 -1926.6678 -8441.2174 -10450.318 -9514.124 -9665.625 -301.45304 322.2435 1916.9694 @@ -108,31 +108,30 @@ Per MPI rank memory allocation (min/avg/max) = 10.07 | 10.08 | 10.34 Mbytes 70 166.70629 -2383.4827 76.492455 55.020922 0 0 131.51338 -1930.4622 4743.9587 1916.6786 2839.9241 2670.7568 -169.67855 -187.58379 -2256.4529 80 171.82933 -2388.0347 76.463333 49.138785 0 0 125.60212 -1931.0453 2210.1222 -319.99043 330.98785 -394.25628 -44.858027 252.35533 -1985.0908 90 175.7327 -2423.7974 90.784969 63.725029 0 0 154.51 -1930.3722 -917.58179 -3941.9566 -2568.4278 -3415.3121 196.38051 2366.2885 -263.52434 - -AMEOBA/HIPPO timing info: - Init time: 0.0370802 0.00577897 - Hal time: 0.0365961 0.570352 - Mpole time: 0.548509 8.54854 - Induce time: 4.8345 75.346 - Polar time: 0.95968 14.9567 - Total time: 6.4164 - 100 173.73319 -2422.3616 99.761403 57.29505 0 0 157.05645 -1930.2461 -3586.4169 -5733.9943 -5881.4025 -6235.1905 -230.75166 959.02899 406.2349 -Loop time of 6.44751 on 32 procs for 100 steps with 648 atoms +Loop time of 6.48935 on 32 procs for 100 steps with 648 atoms -Performance: 1.340 ns/day, 17.910 hours/ns, 15.510 timesteps/s +Performance: 1.331 ns/day, 18.026 hours/ns, 15.410 timesteps/s 99.8% CPU use with 32 MPI tasks x no OpenMP threads +AMEOBA/HIPPO timing breakdown: + Init time: 0.0357484 0.00553355 + Hal time: 0.0364815 0.564704 + Mpole time: 0.541384 8.38018 + Induce time: 4.89091 75.7073 + Polar time: 0.955739 14.794 + Total time: 6.46029 + MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 6.4102 | 6.4179 | 6.4248 | 0.2 | 99.54 -Bond | 0.00029057 | 0.00042623 | 0.00057421 | 0.0 | 0.01 -Neigh | 0.00040172 | 0.00045575 | 0.00052495 | 0.0 | 0.01 -Comm | 0.016267 | 0.023118 | 0.030703 | 2.6 | 0.36 -Output | 0.0037201 | 0.003804 | 0.0040605 | 0.1 | 0.06 -Modify | 0.00028994 | 0.00038094 | 0.0005128 | 0.0 | 0.01 -Other | | 0.001461 | | | 0.02 +Pair | 6.4536 | 6.4614 | 6.4698 | 0.2 | 99.57 +Bond | 0.00025488 | 0.00038243 | 0.00051904 | 0.0 | 0.01 +Neigh | 0.00033789 | 0.00036365 | 0.00040331 | 0.0 | 0.01 +Comm | 0.013439 | 0.021894 | 0.02956 | 2.9 | 0.34 +Output | 0.0038126 | 0.0038325 | 0.0040712 | 0.1 | 0.06 +Modify | 0.00021256 | 0.00028049 | 0.00035212 | 0.0 | 0.00 +Other | | 0.001189 | | | 0.02 Nlocal: 20.25 ave 26 max 12 min Histogram: 1 1 3 1 2 7 3 11 1 2 diff --git a/examples/amoeba/log.water_box.hippo.1.test b/examples/amoeba/log.water_box.hippo.1.test index d519e1ba86..ffac98ae05 100644 --- a/examples/amoeba/log.water_box.hippo.1.test +++ b/examples/amoeba/log.water_box.hippo.1.test @@ -12,8 +12,8 @@ dihedral_style none # per-atom properties required by AMOEBA or HIPPO fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes -fix extra2 all property/atom i_polaxe +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 # read data file @@ -39,7 +39,7 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of special neighbors special bonds CPU = 0.000 seconds - read_data CPU = 0.007 seconds + read_data CPU = 0.012 seconds # force field @@ -55,7 +55,7 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of 1-5 neighbors 2 = max # of special neighbors - special bonds CPU = 0.000 seconds + special bonds CPU = 0.001 seconds # thermo output @@ -98,7 +98,7 @@ Neighbor list info ... stencil: half/bin/3d bin: standard AMOEBA/HIPPO group count: 216 -Per MPI rank memory allocation (min/avg/max) = 10.89 | 10.89 | 10.89 Mbytes +Per MPI rank memory allocation (min/avg/max) = 57.8 | 57.8 | 57.8 Mbytes Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] 0 0 -2188.594 166.82637 77.478353 0 0 244.30473 -1944.2893 -10859.589 -9285.4645 -11598.049 -11695.254 -282.7072 3164.4148 2495.2578 10 100.94691 -2350.192 116.13156 88.56605 0 0 204.69761 -1950.8098 -11480.919 -13574.139 -12190.797 -12798.212 -263.77028 280.62864 1974.1486 @@ -110,33 +110,32 @@ Per MPI rank memory allocation (min/avg/max) = 10.89 | 10.89 | 10.89 Mbytes 70 184.86849 -2391.6106 39.916931 35.978152 0 0 75.895083 -1959.1811 -2146.9339 -4993.4021 -4095.6729 -4897.5768 -833.09046 1542.411 -1539.5266 80 164.75795 -2406.3017 101.94229 33.067832 0 0 135.01013 -1953.542 -8779.3265 -10545.409 -10418.702 -12098.858 -1319.194 1750.3511 -275.1272 90 151.17491 -2434.6876 152.21826 41.301673 0 0 193.51993 -1949.6141 -13330.691 -15436.505 -13791.461 -16934.674 149.25497 2289.1026 976.14333 - -AMEOBA/HIPPO timing info: - Init time: 0.0135815 0.00137415 - Repls time: 1.1283 11.4159 - Disp time: 0.913907 9.24672 - Mpole time: 1.76939 17.9023 - Induce time: 3.50511 35.4639 - Polar time: 2.23426 22.6058 - Qxfer time: 0.319009 3.22767 - Total time: 9.88358 - 100 166.99163 -2452.5298 143.57768 35.341459 0 0 178.91914 -1951.5533 -14918.51 -16077.49 -17353.738 -18140.466 19.009088 1487.0469 1084.0231 -Loop time of 9.91124 on 1 procs for 100 steps with 648 atoms +Loop time of 9.27469 on 1 procs for 100 steps with 648 atoms -Performance: 0.872 ns/day, 27.531 hours/ns, 10.090 timesteps/s -98.6% CPU use with 1 MPI tasks x no OpenMP threads +Performance: 0.932 ns/day, 25.763 hours/ns, 10.782 timesteps/s +99.0% CPU use with 1 MPI tasks x no OpenMP threads + +AMEOBA/HIPPO timing breakdown: + Init time: 0.012403 0.00134127 + Repulse time: 1.04474 11.2979 + Disp time: 0.83125 8.98919 + Mpole time: 1.66803 18.0382 + Induce time: 3.2846 35.5199 + Polar time: 2.12371 22.9659 + Qxfer time: 0.282486 3.05482 + Total time: 9.24722 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 9.8837 | 9.8837 | 9.8837 | 0.0 | 99.72 -Bond | 0.0026063 | 0.0026063 | 0.0026063 | 0.0 | 0.03 -Neigh | 0.0058854 | 0.0058854 | 0.0058854 | 0.0 | 0.06 -Comm | 0.002753 | 0.002753 | 0.002753 | 0.0 | 0.03 -Output | 0.014779 | 0.014779 | 0.014779 | 0.0 | 0.15 -Modify | 0.00071385 | 0.00071385 | 0.00071385 | 0.0 | 0.01 -Other | | 0.0007555 | | | 0.01 +Pair | 9.2473 | 9.2473 | 9.2473 | 0.0 | 99.70 +Bond | 0.0023727 | 0.0023727 | 0.0023727 | 0.0 | 0.03 +Neigh | 0.0055338 | 0.0055338 | 0.0055338 | 0.0 | 0.06 +Comm | 0.0021428 | 0.0021428 | 0.0021428 | 0.0 | 0.02 +Output | 0.016044 | 0.016044 | 0.016044 | 0.0 | 0.17 +Modify | 0.00059122 | 0.00059122 | 0.00059122 | 0.0 | 0.01 +Other | | 0.0006893 | | | 0.01 Nlocal: 648 ave 648 max 648 min Histogram: 1 0 0 0 0 0 0 0 0 0 @@ -150,4 +149,4 @@ Ave neighs/atom = 151.99074 Ave special neighs/atom = 2 Neighbor list builds = 2 Dangerous builds = 0 -Total wall time: 0:00:10 +Total wall time: 0:00:09 diff --git a/examples/amoeba/log.water_box.hippo.32.test b/examples/amoeba/log.water_box.hippo.32.test index d5208570c4..5bf59135a6 100644 --- a/examples/amoeba/log.water_box.hippo.32.test +++ b/examples/amoeba/log.water_box.hippo.32.test @@ -12,8 +12,8 @@ dihedral_style none # per-atom properties required by AMOEBA or HIPPO fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes -fix extra2 all property/atom i_polaxe +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 # read data file @@ -39,7 +39,7 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of special neighbors special bonds CPU = 0.002 seconds - read_data CPU = 0.026 seconds + read_data CPU = 0.020 seconds # force field @@ -98,7 +98,7 @@ Neighbor list info ... stencil: half/bin/3d bin: standard AMOEBA/HIPPO group count: 216 -Per MPI rank memory allocation (min/avg/max) = 10.07 | 10.08 | 10.34 Mbytes +Per MPI rank memory allocation (min/avg/max) = 57.03 | 57.04 | 57.3 Mbytes Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] 0 0 -2188.594 166.82637 77.478353 0 0 244.30473 -1944.2893 -10859.589 -9285.4645 -11598.049 -11695.254 -282.7072 3164.4148 2495.2578 10 100.94691 -2350.192 116.13156 88.56605 0 0 204.69761 -1950.8098 -11480.919 -13574.139 -12190.797 -12798.212 -263.77028 280.62864 1974.1486 @@ -110,33 +110,32 @@ Per MPI rank memory allocation (min/avg/max) = 10.07 | 10.08 | 10.34 Mbytes 70 184.86849 -2391.6106 39.916931 35.978152 0 0 75.895083 -1959.1811 -2146.9339 -4993.4021 -4095.6729 -4897.5768 -833.09046 1542.411 -1539.5266 80 164.75795 -2406.3017 101.94229 33.067832 0 0 135.01013 -1953.542 -8779.3265 -10545.409 -10418.702 -12098.858 -1319.194 1750.3511 -275.1272 90 151.17491 -2434.6876 152.21826 41.301673 0 0 193.51993 -1949.6141 -13330.691 -15436.505 -13791.461 -16934.674 149.25497 2289.1026 976.14333 - -AMEOBA/HIPPO timing info: - Init time: 0.0207283 0.0128038 - Repls time: 0.0699766 4.32242 - Disp time: 0.149724 9.24836 - Mpole time: 0.274572 16.9601 - Induce time: 0.755302 46.6545 - Polar time: 0.336004 20.7548 - Qxfer time: 0.0126115 0.779003 - Total time: 1.61892 - 100 166.99163 -2452.5298 143.57768 35.341459 0 0 178.91914 -1951.5533 -14918.51 -16077.49 -17353.738 -18140.466 19.009088 1487.0469 1084.0231 -Loop time of 1.64289 on 32 procs for 100 steps with 648 atoms +Loop time of 1.60312 on 32 procs for 100 steps with 648 atoms -Performance: 5.259 ns/day, 4.564 hours/ns, 60.868 timesteps/s -99.7% CPU use with 32 MPI tasks x no OpenMP threads +Performance: 5.389 ns/day, 4.453 hours/ns, 62.378 timesteps/s +99.8% CPU use with 32 MPI tasks x no OpenMP threads + +AMEOBA/HIPPO timing breakdown: + Init time: 0.019742 0.012493 + Repulse time: 0.0675395 4.27399 + Disp time: 0.142632 9.02596 + Mpole time: 0.265051 16.7728 + Induce time: 0.740525 46.8614 + Polar time: 0.332551 21.0442 + Qxfer time: 0.0121995 0.772001 + Total time: 1.58025 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 1.6154 | 1.62 | 1.6242 | 0.2 | 98.61 -Bond | 0.00017997 | 0.0002499 | 0.00040555 | 0.0 | 0.02 -Neigh | 0.00042001 | 0.00048474 | 0.00059125 | 0.0 | 0.03 -Comm | 0.012961 | 0.017336 | 0.021852 | 1.7 | 1.06 -Output | 0.0036708 | 0.0037324 | 0.0039355 | 0.1 | 0.23 -Modify | 0.0001113 | 0.00018285 | 0.00027874 | 0.0 | 0.01 -Other | | 0.0009209 | | | 0.06 +Pair | 1.5773 | 1.5814 | 1.5855 | 0.2 | 98.65 +Bond | 0.00015755 | 0.00023663 | 0.0003199 | 0.0 | 0.01 +Neigh | 0.00036065 | 0.00038248 | 0.00042908 | 0.0 | 0.02 +Comm | 0.01209 | 0.016226 | 0.020477 | 1.7 | 1.01 +Output | 0.0037797 | 0.0038027 | 0.0040217 | 0.1 | 0.24 +Modify | 0.00010094 | 0.00013624 | 0.00018983 | 0.0 | 0.01 +Other | | 0.0008996 | | | 0.06 Nlocal: 20.25 ave 27 max 12 min Histogram: 1 1 3 1 6 2 10 4 2 2 diff --git a/examples/amoeba/log.water_dimer.amoeba.1.test b/examples/amoeba/log.water_dimer.amoeba.1.test index c243c663cc..c982de2d9d 100644 --- a/examples/amoeba/log.water_dimer.amoeba.1.test +++ b/examples/amoeba/log.water_dimer.amoeba.1.test @@ -12,8 +12,8 @@ dihedral_style none # per-atom properties required by AMOEBA or HIPPO fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes -fix extra2 all property/atom i_polaxe +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 # read data file @@ -39,7 +39,7 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of special neighbors special bonds CPU = 0.000 seconds - read_data CPU = 0.007 seconds + read_data CPU = 0.008 seconds # force field @@ -97,7 +97,7 @@ Neighbor list info ... bin: standard WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (../domain.cpp:974) AMOEBA/HIPPO group count: 2 -Per MPI rank memory allocation (min/avg/max) = 9.855 | 9.855 | 9.855 Mbytes +Per MPI rank memory allocation (min/avg/max) = 49.59 | 49.59 | 49.59 Mbytes Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] 0 0 -5.1627563 0.025695395 0.71581114 0 0 0.74150653 -4.4212497 -12260.522 -43226.042 39448.214 -33003.739 -85.160886 -28101.905 -72.971988 10 1.1174766 -4.7928792 0.045080327 0.30848527 0 0 0.35356559 -4.4226587 -14728.416 11456.119 -52592.829 -3262.8454 70.868937 29494.268 57.977562 @@ -109,31 +109,30 @@ Per MPI rank memory allocation (min/avg/max) = 9.855 | 9.855 | 9.855 Mbytes 70 10.385926 -4.8250769 0.022572262 0.22235766 0 0 0.24492992 -4.4253547 -1117.3665 19070.918 -36063.612 11648.813 61.067533 25754.59 53.919881 80 12.797691 -5.123735 0.023756795 0.48275385 0 0 0.50651065 -4.4264869 -6491.9826 -28436.037 20681.908 -14176.121 -64.024669 -35737.052 -52.583533 90 12.569481 -4.8303379 0.060369422 0.15670502 0 0 0.21707444 -4.4259273 -16762.536 1720.5855 -47624.986 -6793.7441 59.966729 30024.566 52.339671 - -AMEOBA/HIPPO timing info: - Init time: 0.000111558 0.0206865 - Hal time: 0.000425262 7.88575 - Mpole time: 0.000608653 11.2864 - Induce time: 0.00283871 52.6391 - Polar time: 0.00139471 25.8625 - Total time: 0.00539279 - 100 17.750788 -5.1195235 0.039885925 0.38711474 0 0 0.42700067 -4.4279642 -10817.92 -21833.456 4186.8301 -18211.329 -43.11086 -32664.671 -41.508916 -Loop time of 0.00640556 on 1 procs for 100 steps with 6 atoms +Loop time of 0.00655818 on 1 procs for 100 steps with 6 atoms -Performance: 1348.828 ns/day, 0.018 hours/ns, 15611.435 timesteps/s -79.3% CPU use with 1 MPI tasks x no OpenMP threads +Performance: 1317.439 ns/day, 0.018 hours/ns, 15248.138 timesteps/s +98.5% CPU use with 1 MPI tasks x no OpenMP threads + +AMEOBA/HIPPO timing breakdown: + Init time: 0.000126483 0.0233682 + Hal time: 0.000471055 8.70292 + Mpole time: 0.000619314 11.4421 + Induce time: 0.00270856 50.0417 + Polar time: 0.00147122 27.1814 + Total time: 0.00541261 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.0054675 | 0.0054675 | 0.0054675 | 0.0 | 85.36 -Bond | 9.3071e-05 | 9.3071e-05 | 9.3071e-05 | 0.0 | 1.45 +Pair | 0.005443 | 0.005443 | 0.005443 | 0.0 | 83.00 +Bond | 9.6579e-05 | 9.6579e-05 | 9.6579e-05 | 0.0 | 1.47 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 1.5103e-05 | 1.5103e-05 | 1.5103e-05 | 0.0 | 0.24 -Output | 0.00072279 | 0.00072279 | 0.00072279 | 0.0 | 11.28 -Modify | 4.4005e-05 | 4.4005e-05 | 4.4005e-05 | 0.0 | 0.69 -Other | | 6.307e-05 | | | 0.98 +Comm | 1.7434e-05 | 1.7434e-05 | 1.7434e-05 | 0.0 | 0.27 +Output | 0.0008951 | 0.0008951 | 0.0008951 | 0.0 | 13.65 +Modify | 5.161e-05 | 5.161e-05 | 5.161e-05 | 0.0 | 0.79 +Other | | 5.444e-05 | | | 0.83 Nlocal: 6 ave 6 max 6 min Histogram: 1 0 0 0 0 0 0 0 0 0 diff --git a/examples/amoeba/log.water_dimer.amoeba.4.test b/examples/amoeba/log.water_dimer.amoeba.4.test index 9c351d757b..026fcfdbcc 100644 --- a/examples/amoeba/log.water_dimer.amoeba.4.test +++ b/examples/amoeba/log.water_dimer.amoeba.4.test @@ -12,8 +12,8 @@ dihedral_style none # per-atom properties required by AMOEBA or HIPPO fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes -fix extra2 all property/atom i_polaxe +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 # read data file @@ -39,7 +39,7 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of special neighbors special bonds CPU = 0.000 seconds - read_data CPU = 0.008 seconds + read_data CPU = 0.009 seconds # force field @@ -55,7 +55,7 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of 1-5 neighbors 2 = max # of special neighbors - special bonds CPU = 0.001 seconds + special bonds CPU = 0.000 seconds # thermo output @@ -97,7 +97,7 @@ Neighbor list info ... bin: standard WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (../domain.cpp:974) AMOEBA/HIPPO group count: 2 -Per MPI rank memory allocation (min/avg/max) = 9.883 | 10.02 | 10.15 Mbytes +Per MPI rank memory allocation (min/avg/max) = 49.61 | 49.75 | 49.88 Mbytes Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] 0 0 -5.1627563 0.025695395 0.71581114 0 0 0.74150653 -4.4212497 -12260.522 -43226.042 39448.214 -33003.739 -85.160886 -28101.905 -72.971988 10 1.1174766 -4.7928792 0.045080327 0.30848527 0 0 0.35356559 -4.4226587 -14728.416 11456.119 -52592.829 -3262.8454 70.868937 29494.268 57.977562 @@ -109,31 +109,30 @@ Per MPI rank memory allocation (min/avg/max) = 9.883 | 10.02 | 10.15 Mbytes 70 10.385926 -4.8250769 0.022572262 0.22235766 0 0 0.24492992 -4.4253547 -1117.3665 19070.918 -36063.612 11648.813 61.067533 25754.59 53.919881 80 12.797691 -5.123735 0.023756795 0.48275385 0 0 0.50651065 -4.4264869 -6491.9826 -28436.037 20681.908 -14176.121 -64.024669 -35737.052 -52.583533 90 12.569481 -4.8303379 0.060369422 0.15670502 0 0 0.21707444 -4.4259273 -16762.536 1720.5855 -47624.986 -6793.7441 59.966729 30024.566 52.339671 - -AMEOBA/HIPPO timing info: - Init time: 0.000634572 0.0450252 - Hal time: 0.000117808 0.835889 - Mpole time: 0.000691769 4.90835 - Induce time: 0.0116228 82.4677 - Polar time: 0.0010122 7.18191 - Total time: 0.0140937 - 100 17.750788 -5.1195235 0.039885925 0.38711474 0 0 0.42700067 -4.4279642 -10817.92 -21833.456 4186.8301 -18211.329 -43.11086 -32664.671 -41.508916 -Loop time of 0.0169629 on 4 procs for 100 steps with 6 atoms +Loop time of 0.0167554 on 4 procs for 100 steps with 6 atoms -Performance: 509.347 ns/day, 0.047 hours/ns, 5895.222 timesteps/s +Performance: 515.654 ns/day, 0.047 hours/ns, 5968.213 timesteps/s 99.4% CPU use with 4 MPI tasks x no OpenMP threads +AMEOBA/HIPPO timing breakdown: + Init time: 0.000555846 0.0390251 + Hal time: 0.000129733 0.910835 + Mpole time: 0.000783914 5.50375 + Induce time: 0.0115771 81.2811 + Polar time: 0.00118294 8.30522 + Total time: 0.0142433 + MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.014227 | 0.014356 | 0.014521 | 0.1 | 84.63 -Bond | 2.4327e-05 | 5.1278e-05 | 8.6189e-05 | 0.0 | 0.30 +Pair | 0.013911 | 0.014439 | 0.0147 | 0.3 | 86.18 +Bond | 1.196e-05 | 4.4667e-05 | 8.5848e-05 | 0.0 | 0.27 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.00067884 | 0.00079493 | 0.00099578 | 0.0 | 4.69 -Output | 0.0011363 | 0.0012476 | 0.0013572 | 0.2 | 7.35 -Modify | 3.5088e-05 | 3.8645e-05 | 4.4792e-05 | 0.0 | 0.23 -Other | | 0.0004741 | | | 2.79 +Comm | 0.00060682 | 0.00082002 | 0.001342 | 0.0 | 4.89 +Output | 0.00098235 | 0.0010281 | 0.0011458 | 0.2 | 6.14 +Modify | 2.2946e-05 | 3.473e-05 | 4.2983e-05 | 0.0 | 0.21 +Other | | 0.0003885 | | | 2.32 Nlocal: 1.5 ave 3 max 0 min Histogram: 2 0 0 0 0 0 0 0 0 2 diff --git a/examples/amoeba/log.water_dimer.hippo.1.test b/examples/amoeba/log.water_dimer.hippo.1.test index a4d1c6b668..7ec0d856e7 100644 --- a/examples/amoeba/log.water_dimer.hippo.1.test +++ b/examples/amoeba/log.water_dimer.hippo.1.test @@ -12,8 +12,8 @@ dihedral_style none # per-atom properties required by AMOEBA or HIPPO fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes -fix extra2 all property/atom i_polaxe +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 # read data file @@ -39,7 +39,7 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of special neighbors special bonds CPU = 0.000 seconds - read_data CPU = 0.006 seconds + read_data CPU = 0.008 seconds # force field @@ -99,7 +99,7 @@ Neighbor list info ... bin: standard WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (../domain.cpp:974) AMOEBA/HIPPO group count: 2 -Per MPI rank memory allocation (min/avg/max) = 9.855 | 9.855 | 9.855 Mbytes +Per MPI rank memory allocation (min/avg/max) = 49.15 | 49.15 | 49.15 Mbytes Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] 0 0 -5.0101954 0.025695395 0.51472748 0 0 0.54042288 -4.4697726 -11875.159 -38149.178 29162.678 -26638.977 -70.63422 -24614.614 -58.505595 10 0.75132894 -4.7952077 0.028216017 0.28494196 0 0 0.31315798 -4.4708519 -13243.822 12661.254 -49613.657 -2923.1497 69.449413 29456.684 56.087663 @@ -111,33 +111,32 @@ Per MPI rank memory allocation (min/avg/max) = 9.855 | 9.855 | 9.855 Mbytes 70 5.3145827 -4.8748857 0.025797484 0.29875503 0 0 0.32455252 -4.4711244 -10208.876 26324.134 -49272.688 -8697.2875 84.479942 36185.667 57.000355 80 3.8409793 -5.0262066 0.027669388 0.47104466 0 0 0.49871405 -4.4702464 -9777.1809 -52088.554 28053.855 -6033.4555 -94.607853 -44638.417 -59.108505 90 3.0683704 -4.8369716 0.035455716 0.28466932 0 0 0.32012503 -4.4711155 -10626.245 31066.635 -49425.925 -14107.889 87.765958 34632.905 52.101981 - -AMEOBA/HIPPO timing info: - Init time: 0.000122127 0.0207713 - Repls time: 0.000661596 11.2524 - Disp time: 0.000406536 6.91434 - Mpole time: 0.00103934 17.677 - Induce time: 0.00224082 38.1118 - Polar time: 0.00123925 21.0772 - Qxfer time: 0.000164716 2.80148 - Total time: 0.00587961 - 100 3.5262799 -4.9906817 0.016687539 0.45011301 0 0 0.46680055 -4.4713252 5216.7691 -34991.221 43883.163 6082.1058 -95.830393 -48645.129 -64.784334 -Loop time of 0.00703205 on 1 procs for 100 steps with 6 atoms +Loop time of 0.00568827 on 1 procs for 100 steps with 6 atoms -Performance: 1228.660 ns/day, 0.020 hours/ns, 14220.604 timesteps/s -94.9% CPU use with 1 MPI tasks x no OpenMP threads +Performance: 1518.916 ns/day, 0.016 hours/ns, 17580.041 timesteps/s +76.9% CPU use with 1 MPI tasks x no OpenMP threads + +AMEOBA/HIPPO timing breakdown: + Init time: 0.00011293 0.024348 + Repulse time: 0.000604058 13.0236 + Disp time: 0.000336908 7.26382 + Mpole time: 0.000853828 18.4087 + Induce time: 0.00158723 34.2211 + Polar time: 0.000996193 21.4782 + Qxfer time: 0.000142246 3.06686 + Total time: 0.00463817 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.0059768 | 0.0059768 | 0.0059768 | 0.0 | 84.99 -Bond | 9.2998e-05 | 9.2998e-05 | 9.2998e-05 | 0.0 | 1.32 +Pair | 0.0046663 | 0.0046663 | 0.0046663 | 0.0 | 82.03 +Bond | 7.8168e-05 | 7.8168e-05 | 7.8168e-05 | 0.0 | 1.37 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 1.7052e-05 | 1.7052e-05 | 1.7052e-05 | 0.0 | 0.24 -Output | 0.00082231 | 0.00082231 | 0.00082231 | 0.0 | 11.69 -Modify | 5.0238e-05 | 5.0238e-05 | 5.0238e-05 | 0.0 | 0.71 -Other | | 7.262e-05 | | | 1.03 +Comm | 1.3206e-05 | 1.3206e-05 | 1.3206e-05 | 0.0 | 0.23 +Output | 0.00084402 | 0.00084402 | 0.00084402 | 0.0 | 14.84 +Modify | 3.8896e-05 | 3.8896e-05 | 3.8896e-05 | 0.0 | 0.68 +Other | | 4.77e-05 | | | 0.84 Nlocal: 6 ave 6 max 6 min Histogram: 1 0 0 0 0 0 0 0 0 0 diff --git a/examples/amoeba/log.water_dimer.hippo.4.test b/examples/amoeba/log.water_dimer.hippo.4.test index 6283896e4f..cd0767ae54 100644 --- a/examples/amoeba/log.water_dimer.hippo.4.test +++ b/examples/amoeba/log.water_dimer.hippo.4.test @@ -12,8 +12,8 @@ dihedral_style none # per-atom properties required by AMOEBA or HIPPO fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes -fix extra2 all property/atom i_polaxe +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 # read data file @@ -39,7 +39,7 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of special neighbors special bonds CPU = 0.000 seconds - read_data CPU = 0.008 seconds + read_data CPU = 0.009 seconds # force field @@ -55,7 +55,7 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of 1-5 neighbors 2 = max # of special neighbors - special bonds CPU = 0.000 seconds + special bonds CPU = 0.001 seconds # thermo output @@ -99,7 +99,7 @@ Neighbor list info ... bin: standard WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (../domain.cpp:974) AMOEBA/HIPPO group count: 2 -Per MPI rank memory allocation (min/avg/max) = 9.883 | 10.02 | 10.15 Mbytes +Per MPI rank memory allocation (min/avg/max) = 49.18 | 49.31 | 49.44 Mbytes Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] 0 0 -5.0101954 0.025695395 0.51472748 0 0 0.54042288 -4.4697726 -11875.159 -38149.178 29162.678 -26638.977 -70.63422 -24614.614 -58.505595 10 0.75132894 -4.7952077 0.028216017 0.28494196 0 0 0.31315798 -4.4708519 -13243.822 12661.254 -49613.657 -2923.1497 69.449413 29456.684 56.087663 @@ -111,33 +111,32 @@ Per MPI rank memory allocation (min/avg/max) = 9.883 | 10.02 | 10.15 Mbytes 70 5.3145827 -4.8748857 0.025797484 0.29875503 0 0 0.32455252 -4.4711244 -10208.876 26324.134 -49272.688 -8697.2875 84.479942 36185.667 57.000355 80 3.8409793 -5.0262066 0.027669388 0.47104466 0 0 0.49871405 -4.4702464 -9777.1809 -52088.554 28053.855 -6033.4555 -94.607853 -44638.417 -59.108505 90 3.0683704 -4.8369716 0.035455716 0.28466932 0 0 0.32012503 -4.4711155 -10626.245 31066.635 -49425.925 -14107.889 87.765958 34632.905 52.101981 - -AMEOBA/HIPPO timing info: - Init time: 0.00050652 0.0494826 - Repls time: 0.00054788 5.35232 - Disp time: 9.848e-05 0.962064 - Mpole time: 0.000949974 9.28042 - Induce time: 0.00725514 70.8764 - Polar time: 0.000826552 8.0747 - Qxfer time: 4.75238e-05 0.464266 - Total time: 0.0102363 - 100 3.5262799 -4.9906817 0.016687539 0.45011301 0 0 0.46680055 -4.4713252 5216.7691 -34991.221 43883.163 6082.1058 -95.830393 -48645.129 -64.784334 -Loop time of 0.0126885 on 4 procs for 100 steps with 6 atoms +Loop time of 0.0133873 on 4 procs for 100 steps with 6 atoms -Performance: 680.931 ns/day, 0.035 hours/ns, 7881.149 timesteps/s -98.0% CPU use with 4 MPI tasks x no OpenMP threads +Performance: 645.386 ns/day, 0.037 hours/ns, 7469.744 timesteps/s +98.4% CPU use with 4 MPI tasks x no OpenMP threads + +AMEOBA/HIPPO timing breakdown: + Init time: 0.000581606 0.0545512 + Repulse time: 0.000622984 5.84322 + Disp time: 0.000115637 1.0846 + Mpole time: 0.000994723 9.32991 + Induce time: 0.00737161 69.1413 + Polar time: 0.00091816 8.61179 + Qxfer time: 5.1997e-05 0.487701 + Total time: 0.0106617 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.010297 | 0.010486 | 0.01066 | 0.1 | 82.64 -Bond | 1.5435e-05 | 3.8769e-05 | 6.9606e-05 | 0.0 | 0.31 +Pair | 0.010579 | 0.010896 | 0.011085 | 0.2 | 81.39 +Bond | 1.3578e-05 | 4.3855e-05 | 7.6592e-05 | 0.0 | 0.33 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.00054274 | 0.00075815 | 0.00091745 | 0.0 | 5.98 -Output | 0.00089374 | 0.00097565 | 0.0010809 | 0.0 | 7.69 -Modify | 2.4069e-05 | 3.143e-05 | 3.8898e-05 | 0.0 | 0.25 -Other | | 0.0003984 | | | 3.14 +Comm | 0.00058533 | 0.00080957 | 0.0011064 | 0.0 | 6.05 +Output | 0.0011175 | 0.0011761 | 0.0013051 | 0.2 | 8.78 +Modify | 2.4304e-05 | 3.4805e-05 | 4.2149e-05 | 0.0 | 0.26 +Other | | 0.0004266 | | | 3.19 Nlocal: 1.5 ave 3 max 0 min Histogram: 2 0 0 0 0 0 0 0 0 2 diff --git a/examples/amoeba/log.water_hexamer.amoeba.1.test b/examples/amoeba/log.water_hexamer.amoeba.1.test index a866e00da6..5cfdcf9338 100644 --- a/examples/amoeba/log.water_hexamer.amoeba.1.test +++ b/examples/amoeba/log.water_hexamer.amoeba.1.test @@ -12,8 +12,8 @@ dihedral_style none # per-atom properties required by AMOEBA or HIPPO fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes -fix extra2 all property/atom i_polaxe +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 # read data file @@ -39,7 +39,7 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of special neighbors special bonds CPU = 0.000 seconds - read_data CPU = 0.006 seconds + read_data CPU = 0.009 seconds # force field @@ -96,7 +96,7 @@ Neighbor list info ... stencil: half/bin/3d bin: standard AMOEBA/HIPPO group count: 6 -Per MPI rank memory allocation (min/avg/max) = 9.804 | 9.804 | 9.804 Mbytes +Per MPI rank memory allocation (min/avg/max) = 49.53 | 49.53 | 49.53 Mbytes Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] 0 0 -48.469664 1.9820353 2.2499329 0 0 4.2319683 -44.237696 -26322.671 -28303.103 -27669.614 -22995.296 1312.6688 2624.8394 4042.0489 10 6.3616471 -46.626437 1.7910812 0.25704063 0 0 2.0481218 -44.255947 -23813.06 -24671.886 -17167.34 -30208.043 -474.208 -8339.5934 -5278.359 @@ -108,31 +108,30 @@ Per MPI rank memory allocation (min/avg/max) = 9.804 | 9.804 | 9.804 Mbytes 70 11.272241 -45.411622 0.07431614 0.51778317 0 0 0.59209931 -44.248316 32055.564 39306.193 30181.52 25601.501 1373.4778 -4501.0686 -2570.4767 80 14.011502 -46.081444 0.089688317 1.006928 0 0 1.0966163 -44.274812 25661.838 38836.598 12603.734 24205.867 -867.36437 -4211.9639 -2820.6725 90 17.659498 -46.247295 0.21744649 0.82687716 0 0 1.0443237 -44.308098 12101.207 19426.995 14142.311 1046.299 -2157.5418 -2141.2454 -2621.456 - -AMEOBA/HIPPO timing info: - Init time: 0.000317854 0.00755342 - Hal time: 0.00509951 12.1184 - Mpole time: 0.0045403 10.7895 - Induce time: 0.0205332 48.7946 - Polar time: 0.0115735 27.503 - Total time: 0.0420808 - 100 17.630532 -46.788272 0.61811601 0.9654966 0 0 1.5836126 -44.311254 -4455.3587 3961.5737 -11554.095 -7458.8012 -3120.9771 -1532.1706 -1499.0117 -Loop time of 0.0436474 on 1 procs for 100 steps with 18 atoms +Loop time of 0.0438592 on 1 procs for 100 steps with 18 atoms -Performance: 197.950 ns/day, 0.121 hours/ns, 2291.090 timesteps/s -98.0% CPU use with 1 MPI tasks x no OpenMP threads +Performance: 196.994 ns/day, 0.122 hours/ns, 2280.022 timesteps/s +95.1% CPU use with 1 MPI tasks x no OpenMP threads + +AMEOBA/HIPPO timing breakdown: + Init time: 0.000324764 0.00770058 + Hal time: 0.00500441 11.8661 + Mpole time: 0.00442974 10.5035 + Induce time: 0.0210286 49.8617 + Polar time: 0.0113696 26.9588 + Total time: 0.042174 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.042165 | 0.042165 | 0.042165 | 0.0 | 96.60 -Bond | 0.00020639 | 0.00020639 | 0.00020639 | 0.0 | 0.47 +Pair | 0.042221 | 0.042221 | 0.042221 | 0.0 | 96.26 +Bond | 0.00021632 | 0.00021632 | 0.00021632 | 0.0 | 0.49 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 1.9457e-05 | 1.9457e-05 | 1.9457e-05 | 0.0 | 0.04 -Output | 0.0011074 | 0.0011074 | 0.0011074 | 0.0 | 2.54 -Modify | 7.3538e-05 | 7.3538e-05 | 7.3538e-05 | 0.0 | 0.17 -Other | | 7.545e-05 | | | 0.17 +Comm | 1.6322e-05 | 1.6322e-05 | 1.6322e-05 | 0.0 | 0.04 +Output | 0.0012472 | 0.0012472 | 0.0012472 | 0.0 | 2.84 +Modify | 7.9638e-05 | 7.9638e-05 | 7.9638e-05 | 0.0 | 0.18 +Other | | 7.889e-05 | | | 0.18 Nlocal: 18 ave 18 max 18 min Histogram: 1 0 0 0 0 0 0 0 0 0 diff --git a/examples/amoeba/log.water_hexamer.amoeba.4.test b/examples/amoeba/log.water_hexamer.amoeba.4.test index 9bc98e71cf..3a27656e78 100644 --- a/examples/amoeba/log.water_hexamer.amoeba.4.test +++ b/examples/amoeba/log.water_hexamer.amoeba.4.test @@ -12,8 +12,8 @@ dihedral_style none # per-atom properties required by AMOEBA or HIPPO fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes -fix extra2 all property/atom i_polaxe +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 # read data file @@ -55,7 +55,7 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of 1-5 neighbors 2 = max # of special neighbors - special bonds CPU = 0.001 seconds + special bonds CPU = 0.000 seconds # thermo output @@ -97,7 +97,7 @@ Neighbor list info ... bin: standard WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (../domain.cpp:974) AMOEBA/HIPPO group count: 6 -Per MPI rank memory allocation (min/avg/max) = 9.833 | 9.833 | 9.833 Mbytes +Per MPI rank memory allocation (min/avg/max) = 49.56 | 49.56 | 49.56 Mbytes Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] 0 0 -48.469664 1.9820353 2.2499329 0 0 4.2319683 -44.237696 -26322.671 -28303.103 -27669.614 -22995.296 1312.6688 2624.8394 4042.0489 10 6.3616471 -46.626437 1.7910812 0.25704063 0 0 2.0481218 -44.255947 -23813.06 -24671.886 -17167.34 -30208.043 -474.208 -8339.5934 -5278.359 @@ -109,31 +109,30 @@ Per MPI rank memory allocation (min/avg/max) = 9.833 | 9.833 | 9.833 Mbytes 70 11.272241 -45.411622 0.07431614 0.51778317 0 0 0.59209931 -44.248316 32055.564 39306.193 30181.52 25601.501 1373.4778 -4501.0686 -2570.4767 80 14.011502 -46.081444 0.089688317 1.006928 0 0 1.0966163 -44.274812 25661.838 38836.598 12603.734 24205.867 -867.36437 -4211.9639 -2820.6725 90 17.659498 -46.247295 0.21744649 0.82687716 0 0 1.0443237 -44.308098 12101.207 19426.995 14142.311 1046.299 -2157.5418 -2141.2454 -2621.456 - -AMEOBA/HIPPO timing info: - Init time: 0.000876489 0.0216648 - Hal time: 0.0012315 3.04398 - Mpole time: 0.00349354 8.63522 - Induce time: 0.0293642 72.5816 - Polar time: 0.00547642 13.5365 - Total time: 0.0404569 - 100 17.630532 -46.788272 0.61811601 0.9654966 0 0 1.5836126 -44.311254 -4455.3587 3961.5737 -11554.095 -7458.8012 -3120.9771 -1532.1706 -1499.0117 -Loop time of 0.0431834 on 4 procs for 100 steps with 18 atoms +Loop time of 0.0405754 on 4 procs for 100 steps with 18 atoms -Performance: 200.077 ns/day, 0.120 hours/ns, 2315.706 timesteps/s -97.8% CPU use with 4 MPI tasks x no OpenMP threads +Performance: 212.937 ns/day, 0.113 hours/ns, 2464.547 timesteps/s +98.9% CPU use with 4 MPI tasks x no OpenMP threads + +AMEOBA/HIPPO timing breakdown: + Init time: 0.000756446 0.0198927 + Hal time: 0.00120064 3.15739 + Mpole time: 0.00338295 8.89637 + Induce time: 0.0273688 71.9733 + Polar time: 0.00530425 13.9489 + Total time: 0.0380263 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.040628 | 0.040702 | 0.04082 | 0.0 | 94.25 -Bond | 7.2822e-05 | 9.4953e-05 | 0.00011572 | 0.0 | 0.22 +Pair | 0.03816 | 0.038221 | 0.038312 | 0.0 | 94.20 +Bond | 7.0759e-05 | 8.5222e-05 | 0.00010449 | 0.0 | 0.21 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.00067844 | 0.00088282 | 0.0010398 | 0.0 | 2.04 -Output | 0.0010464 | 0.0010868 | 0.0011886 | 0.2 | 2.52 -Modify | 4.2857e-05 | 5.2307e-05 | 6.3734e-05 | 0.0 | 0.12 -Other | | 0.0003646 | | | 0.84 +Comm | 0.00065721 | 0.00081724 | 0.00093857 | 0.0 | 2.01 +Output | 0.0010275 | 0.0010663 | 0.0011758 | 0.2 | 2.63 +Modify | 3.3884e-05 | 4.422e-05 | 5.7037e-05 | 0.0 | 0.11 +Other | | 0.000341 | | | 0.84 Nlocal: 4.5 ave 6 max 3 min Histogram: 1 0 0 1 0 0 1 0 0 1 diff --git a/examples/amoeba/log.water_hexamer.hippo.1.test b/examples/amoeba/log.water_hexamer.hippo.1.test index a11319fd33..15d107a11b 100644 --- a/examples/amoeba/log.water_hexamer.hippo.1.test +++ b/examples/amoeba/log.water_hexamer.hippo.1.test @@ -12,8 +12,8 @@ dihedral_style none # per-atom properties required by AMOEBA or HIPPO fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes -fix extra2 all property/atom i_polaxe +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 # read data file @@ -39,7 +39,7 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of special neighbors special bonds CPU = 0.000 seconds - read_data CPU = 0.006 seconds + read_data CPU = 0.007 seconds # force field @@ -98,7 +98,7 @@ Neighbor list info ... stencil: half/bin/3d bin: standard AMOEBA/HIPPO group count: 6 -Per MPI rank memory allocation (min/avg/max) = 9.804 | 9.804 | 9.804 Mbytes +Per MPI rank memory allocation (min/avg/max) = 49.1 | 49.1 | 49.1 Mbytes Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] 0 0 -47.362156 1.9820353 1.6634749 0 0 3.6455102 -43.716646 -34513.768 -42206.078 -31383.641 -29951.584 2850.1184 3579.9253 5768.3698 10 11.52238 -45.959856 1.53397 0.085100522 0 0 1.6190706 -43.756903 -28644.676 -34867.94 -19324.955 -32842.522 -370.63233 -6452.0859 -4002.3535 @@ -110,33 +110,32 @@ Per MPI rank memory allocation (min/avg/max) = 9.804 | 9.804 | 9.804 Mbytes 70 26.129957 -46.022729 0.30434543 0.56770169 0 0 0.87204711 -43.826579 3919.9866 -2755.6905 11500.428 517.54333 5626.9543 -2238.5786 86.305984 80 17.768494 -46.309777 1.1680612 0.45551823 0 0 1.6235794 -43.785801 -18335.898 -22168.789 -14488.992 -20048.346 7343.173 -2646.2196 -2525.6625 90 8.3822494 -47.063502 2.0182644 0.88875358 0 0 2.9070179 -43.731724 -33693.203 -43487.996 -15178.35 -43214.494 2412.6411 1993.0113 1780.7512 - -AMEOBA/HIPPO timing info: - Init time: 0.000259847 0.00745584 - Repls time: 0.00547792 15.7179 - Disp time: 0.00244273 7.00898 - Mpole time: 0.00635244 18.2272 - Induce time: 0.0119383 34.2547 - Polar time: 0.00698809 20.051 - Qxfer time: 0.00138825 3.98334 - Total time: 0.0348515 - 100 8.6486333 -46.517402 1.9551958 0.38696887 0 0 2.3421647 -43.736979 -34734.97 -34372.659 -28372.146 -42286.799 226.18821 40.353457 -755.93912 -Loop time of 0.0363248 on 1 procs for 100 steps with 18 atoms +Loop time of 0.0399433 on 1 procs for 100 steps with 18 atoms -Performance: 237.854 ns/day, 0.101 hours/ns, 2752.942 timesteps/s -98.0% CPU use with 1 MPI tasks x no OpenMP threads +Performance: 216.307 ns/day, 0.111 hours/ns, 2503.548 timesteps/s +92.6% CPU use with 1 MPI tasks x no OpenMP threads + +AMEOBA/HIPPO timing breakdown: + Init time: 0.000295019 0.00770171 + Repulse time: 0.00594736 15.5261 + Disp time: 0.00261218 6.81931 + Mpole time: 0.0069314 18.095 + Induce time: 0.013694 35.7492 + Polar time: 0.00744631 19.4392 + Qxfer time: 0.001375 3.58954 + Total time: 0.0383057 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.034944 | 0.034944 | 0.034944 | 0.0 | 96.20 -Bond | 0.00016367 | 0.00016367 | 0.00016367 | 0.0 | 0.45 +Pair | 0.038344 | 0.038344 | 0.038344 | 0.0 | 96.00 +Bond | 0.00017707 | 0.00017707 | 0.00017707 | 0.0 | 0.44 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 1.8118e-05 | 1.8118e-05 | 1.8118e-05 | 0.0 | 0.05 -Output | 0.0010588 | 0.0010588 | 0.0010588 | 0.0 | 2.91 -Modify | 7.1169e-05 | 7.1169e-05 | 7.1169e-05 | 0.0 | 0.20 -Other | | 6.941e-05 | | | 0.19 +Comm | 1.5549e-05 | 1.5549e-05 | 1.5549e-05 | 0.0 | 0.04 +Output | 0.0012682 | 0.0012682 | 0.0012682 | 0.0 | 3.18 +Modify | 7.0869e-05 | 7.0869e-05 | 7.0869e-05 | 0.0 | 0.18 +Other | | 6.745e-05 | | | 0.17 Nlocal: 18 ave 18 max 18 min Histogram: 1 0 0 0 0 0 0 0 0 0 diff --git a/examples/amoeba/log.water_hexamer.hippo.4.test b/examples/amoeba/log.water_hexamer.hippo.4.test index fa89631c2c..4b0d913edd 100644 --- a/examples/amoeba/log.water_hexamer.hippo.4.test +++ b/examples/amoeba/log.water_hexamer.hippo.4.test @@ -12,8 +12,8 @@ dihedral_style none # per-atom properties required by AMOEBA or HIPPO fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes -fix extra2 all property/atom i_polaxe +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 # read data file @@ -39,7 +39,7 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of special neighbors special bonds CPU = 0.000 seconds - read_data CPU = 0.009 seconds + read_data CPU = 0.008 seconds # force field @@ -55,7 +55,7 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of 1-5 neighbors 2 = max # of special neighbors - special bonds CPU = 0.001 seconds + special bonds CPU = 0.000 seconds # thermo output @@ -99,7 +99,7 @@ Neighbor list info ... bin: standard WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (../domain.cpp:974) AMOEBA/HIPPO group count: 6 -Per MPI rank memory allocation (min/avg/max) = 9.833 | 9.833 | 9.833 Mbytes +Per MPI rank memory allocation (min/avg/max) = 49.13 | 49.13 | 49.13 Mbytes Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] 0 0 -47.362156 1.9820353 1.6634749 0 0 3.6455102 -43.716646 -34513.768 -42206.078 -31383.641 -29951.584 2850.1184 3579.9253 5768.3698 10 11.52238 -45.959856 1.53397 0.085100522 0 0 1.6190706 -43.756903 -28644.676 -34867.94 -19324.955 -32842.522 -370.63233 -6452.0859 -4002.3535 @@ -111,33 +111,32 @@ Per MPI rank memory allocation (min/avg/max) = 9.833 | 9.833 | 9.833 Mbytes 70 26.129957 -46.022729 0.30434543 0.56770169 0 0 0.87204711 -43.826579 3919.9866 -2755.6905 11500.428 517.54333 5626.9543 -2238.5786 86.305984 80 17.768494 -46.309777 1.1680612 0.45551823 0 0 1.6235794 -43.785801 -18335.898 -22168.789 -14488.992 -20048.346 7343.173 -2646.2196 -2525.6625 90 8.3822494 -47.063502 2.0182644 0.88875358 0 0 2.9070179 -43.731724 -33693.203 -43487.996 -15178.35 -43214.494 2412.6411 1993.0113 1780.7512 - -AMEOBA/HIPPO timing info: - Init time: 0.000745036 0.0228122 - Repls time: 0.00327392 10.0244 - Disp time: 0.000684259 2.09513 - Mpole time: 0.00435168 13.3244 - Induce time: 0.0190657 58.3773 - Polar time: 0.00415392 12.7189 - Qxfer time: 0.000380552 1.16521 - Total time: 0.0326595 - 100 8.6486333 -46.517402 1.9551958 0.38696887 0 0 2.3421647 -43.736979 -34734.97 -34372.659 -28372.146 -42286.799 226.18821 40.353457 -755.93912 -Loop time of 0.0358657 on 4 procs for 100 steps with 18 atoms +Loop time of 0.033787 on 4 procs for 100 steps with 18 atoms -Performance: 240.899 ns/day, 0.100 hours/ns, 2788.181 timesteps/s +Performance: 255.719 ns/day, 0.094 hours/ns, 2959.715 timesteps/s 99.9% CPU use with 4 MPI tasks x no OpenMP threads +AMEOBA/HIPPO timing breakdown: + Init time: 0.000724905 0.0236438 + Repulse time: 0.00306516 9.99746 + Disp time: 0.000637502 2.07931 + Mpole time: 0.00397577 12.9676 + Induce time: 0.0181268 59.123 + Polar time: 0.00377543 12.3141 + Qxfer time: 0.000349256 1.13915 + Total time: 0.0306594 + MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.032583 | 0.03291 | 0.033445 | 0.2 | 91.76 -Bond | 5.6993e-05 | 8.0508e-05 | 9.8801e-05 | 0.0 | 0.22 +Pair | 0.030576 | 0.030875 | 0.031306 | 0.2 | 91.38 +Bond | 6.4191e-05 | 7.956e-05 | 0.0001014 | 0.0 | 0.24 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.00070037 | 0.0013312 | 0.0017469 | 1.1 | 3.71 -Output | 0.0010287 | 0.0010873 | 0.0012054 | 0.2 | 3.03 -Modify | 4.2091e-05 | 5.3037e-05 | 6.0581e-05 | 0.0 | 0.15 -Other | | 0.0004036 | | | 1.13 +Comm | 0.00072972 | 0.0012341 | 0.0015501 | 1.0 | 3.65 +Output | 0.0011293 | 0.0011806 | 0.0012922 | 0.2 | 3.49 +Modify | 4.0541e-05 | 4.5677e-05 | 5.4304e-05 | 0.0 | 0.14 +Other | | 0.0003717 | | | 1.10 Nlocal: 4.5 ave 6 max 3 min Histogram: 1 0 0 1 0 0 1 0 0 1 From 75c0287024487f2ba375157e5b7c7fcc8c589724 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Tue, 24 May 2022 16:59:27 -0600 Subject: [PATCH 207/585] modify example input and output files --- examples/amoeba/dump.ubi.1.test | 19492 ---------------- examples/amoeba/dump.ubi.32.test | 19492 ---------------- examples/amoeba/dump.water_box.amoeba.1.test | 7227 ------ examples/amoeba/dump.water_box.amoeba.32.test | 7227 ------ examples/amoeba/dump.water_box.hippo.1.test | 7227 ------ examples/amoeba/dump.water_box.hippo.32.test | 7227 ------ .../amoeba/dump.water_dimer.amoeba.1.test | 165 - .../amoeba/dump.water_dimer.amoeba.4.test | 165 - examples/amoeba/dump.water_dimer.hippo.1.test | 165 - examples/amoeba/dump.water_dimer.hippo.4.test | 165 - .../amoeba/dump.water_hexamer.amoeba.1.test | 297 - .../amoeba/dump.water_hexamer.amoeba.4.test | 297 - .../amoeba/dump.water_hexamer.hippo.1.test | 297 - .../amoeba/dump.water_hexamer.hippo.4.test | 297 - examples/amoeba/in.ubiquitin | 8 +- examples/amoeba/in.ubiquitin.test | 56 - examples/amoeba/in.water_box.amoeba | 2 +- examples/amoeba/in.water_box.amoeba.test | 47 - examples/amoeba/in.water_box.hippo | 2 +- examples/amoeba/in.water_box.hippo.test | 47 - examples/amoeba/in.water_dimer.amoeba | 2 +- examples/amoeba/in.water_dimer.amoeba.test | 47 - examples/amoeba/in.water_dimer.hippo | 2 +- examples/amoeba/in.water_dimer.hippo.test | 47 - examples/amoeba/in.water_hexamer.amoeba | 2 +- examples/amoeba/in.water_hexamer.amoeba.test | 47 - examples/amoeba/in.water_hexamer.hippo | 2 +- examples/amoeba/in.water_hexamer.hippo.test | 47 - examples/amoeba/log.ubi.1 | 48 +- examples/amoeba/log.ubi.1.test | 162 - examples/amoeba/log.ubi.32 | 48 +- examples/amoeba/log.ubi.32.test | 162 - examples/amoeba/log.water_box.amoeba.1 | 45 +- examples/amoeba/log.water_box.amoeba.1.test | 148 - examples/amoeba/log.water_box.amoeba.32 | 47 +- examples/amoeba/log.water_box.amoeba.32.test | 148 - examples/amoeba/log.water_box.hippo.1 | 51 +- examples/amoeba/log.water_box.hippo.1.test | 152 - examples/amoeba/log.water_box.hippo.32 | 49 +- examples/amoeba/log.water_box.hippo.32.test | 152 - examples/amoeba/log.water_dimer.amoeba.1 | 43 +- examples/amoeba/log.water_dimer.amoeba.1.test | 149 - examples/amoeba/log.water_dimer.amoeba.4 | 43 +- examples/amoeba/log.water_dimer.amoeba.4.test | 149 - examples/amoeba/log.water_dimer.hippo.1 | 47 +- examples/amoeba/log.water_dimer.hippo.1.test | 153 - examples/amoeba/log.water_dimer.hippo.4 | 45 +- examples/amoeba/log.water_dimer.hippo.4.test | 153 - examples/amoeba/log.water_hexamer.amoeba.1 | 43 +- .../amoeba/log.water_hexamer.amoeba.1.test | 148 - examples/amoeba/log.water_hexamer.amoeba.4 | 45 +- .../amoeba/log.water_hexamer.amoeba.4.test | 149 - examples/amoeba/log.water_hexamer.hippo.1 | 45 +- .../amoeba/log.water_hexamer.hippo.1.test | 152 - examples/amoeba/log.water_hexamer.hippo.4 | 47 +- .../amoeba/log.water_hexamer.hippo.4.test | 153 - 56 files changed, 327 insertions(+), 72547 deletions(-) delete mode 100644 examples/amoeba/dump.ubi.1.test delete mode 100644 examples/amoeba/dump.ubi.32.test delete mode 100644 examples/amoeba/dump.water_box.amoeba.1.test delete mode 100644 examples/amoeba/dump.water_box.amoeba.32.test delete mode 100644 examples/amoeba/dump.water_box.hippo.1.test delete mode 100644 examples/amoeba/dump.water_box.hippo.32.test delete mode 100644 examples/amoeba/dump.water_dimer.amoeba.1.test delete mode 100644 examples/amoeba/dump.water_dimer.amoeba.4.test delete mode 100644 examples/amoeba/dump.water_dimer.hippo.1.test delete mode 100644 examples/amoeba/dump.water_dimer.hippo.4.test delete mode 100644 examples/amoeba/dump.water_hexamer.amoeba.1.test delete mode 100644 examples/amoeba/dump.water_hexamer.amoeba.4.test delete mode 100644 examples/amoeba/dump.water_hexamer.hippo.1.test delete mode 100644 examples/amoeba/dump.water_hexamer.hippo.4.test delete mode 100644 examples/amoeba/in.ubiquitin.test delete mode 100644 examples/amoeba/in.water_box.amoeba.test delete mode 100644 examples/amoeba/in.water_box.hippo.test delete mode 100644 examples/amoeba/in.water_dimer.amoeba.test delete mode 100644 examples/amoeba/in.water_dimer.hippo.test delete mode 100644 examples/amoeba/in.water_hexamer.amoeba.test delete mode 100644 examples/amoeba/in.water_hexamer.hippo.test delete mode 100644 examples/amoeba/log.ubi.1.test delete mode 100644 examples/amoeba/log.ubi.32.test delete mode 100644 examples/amoeba/log.water_box.amoeba.1.test delete mode 100644 examples/amoeba/log.water_box.amoeba.32.test delete mode 100644 examples/amoeba/log.water_box.hippo.1.test delete mode 100644 examples/amoeba/log.water_box.hippo.32.test delete mode 100644 examples/amoeba/log.water_dimer.amoeba.1.test delete mode 100644 examples/amoeba/log.water_dimer.amoeba.4.test delete mode 100644 examples/amoeba/log.water_dimer.hippo.1.test delete mode 100644 examples/amoeba/log.water_dimer.hippo.4.test delete mode 100644 examples/amoeba/log.water_hexamer.amoeba.1.test delete mode 100644 examples/amoeba/log.water_hexamer.amoeba.4.test delete mode 100644 examples/amoeba/log.water_hexamer.hippo.1.test delete mode 100644 examples/amoeba/log.water_hexamer.hippo.4.test diff --git a/examples/amoeba/dump.ubi.1.test b/examples/amoeba/dump.ubi.1.test deleted file mode 100644 index 743c5e68dc..0000000000 --- a/examples/amoeba/dump.ubi.1.test +++ /dev/null @@ -1,19492 +0,0 @@ -ITEM: TIMESTEP -0 -ITEM: NUMBER OF ATOMS -9737 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 5.4990000000000002e+01 -0.0000000000000000e+00 4.1909999999999997e+01 -0.0000000000000000e+00 4.1909999999999997e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 9.9631 5.60476 0.008413 6.29384 29.5246 19.0744 -2 2 9.59585 5.61686 40.5223 49.6095 -15.082 -19.7261 -3 2 8.19009 6.07902 40.3725 -38.3002 -36.0401 31.6494 -4 3 7.228 5.27674 40.5663 25.6537 34.3003 -15.2325 -5 4 9.24854 5.32486 0.671238 -4.4712 -3.37565 -7.28982 -6 4 10.3108 6.54317 0.309331 -11.8382 -28.5043 -8.77497 -7 4 10.7093 4.95217 0.170763 9.79439 -2.80927 4.02983 -8 4 10.3426 6.38567 40.0332 -19.5644 -29.2331 3.89265 -9 2 9.77742 4.13431 39.9813 -28.2245 -12.7597 2.79543 -10 2 9.48564 3.81758 38.4974 43.5672 -24.1926 -8.96475 -11 5 10.1176 2.11667 38.0047 -9.19737 11.9016 12.5734 -12 2 9.21456 1.10205 39.2112 31.2522 23.9396 11.6177 -13 4 8.99594 3.48122 40.5964 28.5446 19.8656 -13.413 -14 4 10.8136 3.75653 40.1807 -3.6049 4.77507 7.99264 -15 4 10.0744 4.47991 37.8007 -16.03 7.55553 14.4224 -16 4 8.42529 3.84402 38.2863 -20.8998 9.83371 -6.83213 -17 4 9.47601 1.46641 40.2263 -2.07893 -1.87234 0.341628 -18 4 9.53146 0.065851 39.1813 1.34892 -20.4385 -9.90461 -19 4 8.1577 1.22135 39.0727 -30.8502 -1.48556 -5.54631 -20 1 8.07565 7.408 40.3203 38.3461 4.68909 -14.5778 -21 2 6.84679 8.08521 40.1985 -59.0929 12.5985 8.76694 -22 2 6.18936 7.48414 38.9048 -11.7821 0.575019 41.3478 -23 3 6.7346 7.67531 37.8418 13.9355 0.826162 -41.115 -24 4 8.95137 7.92937 40.1018 -13.7432 5.12585 4.7357 -25 4 6.17099 7.78674 41.0889 17.7478 9.29385 -16.8634 -26 2 7.04543 9.68435 40.1788 6.06779 -36.4281 36.3417 -27 2 5.78315 10.5437 40.1541 10.0153 13.6856 -31.2349 -28 2 4.87823 10.4891 38.8981 8.0898 32.2503 -21.0798 -29 3 5.10035 11.2936 37.9551 -6.38068 -25.249 23.2549 -30 1 3.78765 9.69754 38.9447 7.74282 -10.5609 -2.0448 -31 4 7.77413 9.91905 39.4336 6.93206 10.4159 -38.5359 -32 4 7.65159 10.0279 41.0787 -15.5363 -12.6708 -2.68622 -33 4 6.21166 11.5927 40.0353 -14.0103 -9.11046 14.0038 -34 4 5.24199 10.4471 41.1154 -6.90019 6.03163 0.39253 -35 4 3.64982 9.13451 39.798 -8.63839 -3.4701 -4.98201 -36 4 3.18526 9.53497 38.0983 12.4509 11.2825 18.2671 -37 1 5.03649 6.76821 39.0271 29.2025 12.626 -49.9624 -38 2 4.1742 6.30537 37.9199 2.45922 -5.77224 11.4432 -39 2 2.7281 6.64357 38.2301 -33.27 13.9739 -28.2234 -40 3 2.48558 7.27851 39.247 -7.20167 1.94081 18.2399 -41 4 4.56901 6.92293 39.8729 -36.0812 -3.10094 47.9009 -42 4 4.41115 6.93099 37.0362 4.08063 -6.87028 -11.6053 -43 2 4.30896 4.77224 37.6863 5.60806 -34.2262 -10.7438 -44 2 3.61194 3.83713 38.7945 21.7291 41.8848 -7.6362 -45 2 5.81981 4.32753 37.5156 -0.302636 -10.5955 -12.2236 -46 2 3.74184 2.37563 38.4472 -21.3499 -20.7746 -35.862 -47 4 3.79188 4.51145 36.7016 6.3754 10.432 9.00978 -48 4 2.54774 4.08441 38.8361 -15.7139 1.18722 1.17999 -49 4 4.01487 4.13828 39.7949 0.987415 -11.5324 -1.87366 -50 4 6.38959 4.49596 38.46 -5.87199 -9.93517 1.91854 -51 4 6.36771 4.97617 36.7815 -14.8228 -10.6264 -0.132465 -52 4 5.90888 3.19548 37.1534 1.72477 39.701 11.5881 -53 4 3.39383 2.18531 37.3739 6.37275 7.50384 16.1992 -54 4 3.10231 1.69487 39.022 -2.76045 -1.11045 15.6564 -55 4 4.76015 2.00007 38.4839 16.883 -5.45935 8.37891 -56 1 1.68415 6.36719 37.3348 37.2769 -12.9922 15.6035 -57 2 0.304736 6.65563 37.6783 -19.186 -35.7743 -0.468083 -58 2 54.3638 5.41499 37.39 23.5408 9.01503 -19.9847 -59 3 54.8016 4.481 36.67 -18.0502 12.9096 17.6943 -60 4 1.81134 5.6821 36.5646 -2.38907 6.77101 2.69516 -61 4 0.26398 6.68603 38.7911 -5.02605 17.0245 3.77253 -62 2 54.6928 7.87629 36.9427 9.14228 37.5998 28.2049 -63 2 0.656467 9.08157 36.7109 -0.0956801 -8.96924 -14.639 -64 2 1.56488 9.23116 35.5658 -28.7887 -16.4207 21.28 -65 2 0.518242 10.1807 37.599 12.0453 -33.0617 -42.3022 -66 2 2.2549 10.4284 35.3456 -0.685553 9.51875 21.9154 -67 2 1.26608 11.2953 37.3573 -6.55985 56.8791 72.0683 -68 2 2.14201 11.4551 36.3269 43.9558 24.4422 -61.5967 -69 4 53.8494 8.28091 37.614 11.6877 -9.2043 -14.6276 -70 4 54.1796 7.56606 36.0251 1.84695 0.514683 -15.8045 -71 4 1.67027 8.40603 34.832 -2.56062 3.42592 3.08894 -72 4 54.8243 10.1788 38.4192 -16.1978 -2.83683 23.7337 -73 4 2.90465 10.5398 34.4584 1.04403 1.06161 3.93542 -74 4 1.2044 12.0958 38.199 3.2453 -15.1518 -32.2206 -75 4 2.76002 12.4636 36.1598 -24.4207 -43.5556 11.8549 -76 1 53.0705 5.5478 37.8043 -13.4682 25.7632 10.8407 -77 2 51.945 4.63101 37.5291 33.8243 -29.5042 -37.7332 -78 2 50.7838 5.44293 36.986 4.21111 -0.422475 -19.7833 -79 3 50.2621 6.29965 37.7355 -1.55474 -12.1519 -25.7528 -80 4 52.801 6.45436 38.3333 3.61532 -42.2821 -15.9338 -81 4 52.3053 3.83112 36.7028 -14.0928 30.7972 24.0178 -82 2 51.5456 3.79903 38.7793 9.75018 1.06621 4.26496 -83 2 50.3519 2.79661 38.4832 35.7171 10.1602 1.47909 -84 2 52.8174 3.02556 39.2171 -10.4567 -30.55 12.3487 -85 4 51.3202 4.51835 39.6193 -10.3559 -7.38818 -7.14654 -86 4 50.5612 2.13754 37.5331 -9.75373 16.6535 26.894 -87 4 49.4557 3.43665 38.3668 -10.8276 -7.01925 -6.76558 -88 4 50.2008 2.17632 39.4156 -2.83245 -1.1989 -13.0752 -89 4 53.3224 3.52205 40.064 3.32837 5.49303 2.41605 -90 4 53.5736 2.86114 38.4382 5.5955 2.25759 -8.48168 -91 4 52.5769 1.98664 39.5815 -0.855844 10.0945 -0.110617 -92 1 50.4393 5.19673 35.6351 -19.7264 9.67141 42.9571 -93 2 49.1691 5.71413 35.1171 8.57247 21.8964 -7.76629 -94 2 48.0882 4.65728 35.3507 -19.9883 30.8425 14.9148 -95 3 48.2827 3.53875 34.9335 -4.48089 -38.0316 -8.70437 -96 4 50.7426 4.33028 35.1784 2.31221 -1.81777 -1.86606 -97 4 48.9711 6.6281 35.7521 -11.2206 -0.672417 -16.6265 -98 2 49.2032 6.03091 33.5236 -0.851856 65.2811 26.1578 -99 2 47.9587 6.87959 32.9935 21.6676 -24.5773 11.3759 -100 2 48.0434 7.32811 31.5002 51.7858 -12.5586 -5.19204 -101 2 48.2074 6.22405 30.3724 28.294 -23.2516 17.4346 -102 1 48.1983 6.77555 28.9911 -71.9632 -28.6889 -6.605 -103 4 49.3393 5.11986 33.0139 -2.20502 -45.3575 -27.512 -104 4 50.0955 6.63289 33.1892 -0.645528 -4.64769 17.8413 -105 4 47.8013 7.74388 33.6913 1.36166 0.224784 -7.99748 -106 4 47.0904 6.22572 33.1496 -13.2574 -0.904539 -3.87726 -107 4 49.004 7.98659 31.3992 -27.9616 -9.11626 3.58403 -108 4 47.1978 7.96127 31.27 -20.0009 14.5444 -5.73856 -109 4 47.5417 5.33248 30.4619 -18.467 18.3391 -3.45282 -110 4 49.1897 5.66674 30.5732 -8.59668 22.4275 -14.4147 -111 4 48.9982 7.27964 28.7313 27.9214 19.6218 -9.55881 -112 4 47.3685 7.40493 28.8518 27.8731 -11.8414 7.77703 -113 4 48.0065 6.08598 28.2169 17.275 11.5652 28.2934 -114 1 46.9206 5.03778 35.9702 10.3577 18.9682 5.15831 -115 2 45.6557 4.25932 36.0398 9.08885 -0.641191 -14.1305 -116 2 44.8836 4.39003 34.674 17.924 -7.95306 73.8288 -117 3 45.3111 5.13887 33.8455 4.25406 24.8458 -47.415 -118 4 46.9247 5.98842 36.4259 -8.42518 -21.6093 -9.66 -119 4 45.9322 3.16772 36.074 -4.07513 2.77881 8.35057 -120 2 44.7235 4.66099 37.2497 -7.79148 27.6424 25.8282 -121 3 44.4559 6.1146 37.2032 37.085 -18.356 15.5747 -122 2 45.2448 4.26963 38.7181 22.7861 29.0575 -8.8559 -123 4 43.727 4.13168 37.1283 17.3832 10.5512 -0.864114 -124 4 45.2761 6.59903 37.5183 -34.0557 -21.4787 -11.7364 -125 4 45.8733 4.97275 39.4014 -10.271 -7.81482 -36.7347 -126 4 45.822 3.36133 38.5799 14.1835 -15.9263 3.29814 -127 4 44.4672 3.97387 39.4102 -27.3329 -5.40347 3.37723 -128 1 43.7561 3.68722 34.6039 -10.1769 -38.5504 10.0379 -129 2 42.7898 3.65331 33.5354 16.9998 -6.12306 -24.86 -130 2 41.7694 4.78815 33.7404 2.26966 -0.410412 -51.1213 -131 3 41.2522 5.37284 32.7445 13.6537 -18.3748 18.9894 -132 4 43.5295 2.98811 35.3697 5.99608 22.1557 -16.865 -133 4 43.3523 3.94914 32.5036 -19.5402 -19.5629 37.0771 -134 2 42.0755 2.18627 33.4863 21.9074 34.2086 -29.4327 -135 2 42.9391 0.859767 33.721 -6.85443 30.257 35.6042 -136 2 42.2358 41.4668 33.4285 -9.81834 -3.65893 -31.5778 -137 2 44.2283 0.854864 32.9471 53.2312 13.9788 40.9195 -138 4 41.6117 2.20331 32.4686 -4.39523 -13.2201 2.61812 -139 4 41.2586 2.27352 34.2121 -10.6776 -10.6054 4.67488 -140 4 43.2056 0.83773 34.8124 -0.343624 1.56324 -2.51079 -141 4 42.8118 40.5237 33.3983 6.69029 -0.569008 16.3673 -142 4 41.9597 41.5484 32.3684 -17.7546 -2.75522 -9.07631 -143 4 41.3245 41.3357 34.0216 -8.62626 -3.98831 3.9624 -144 4 44.0827 0.853311 31.8896 -3.53557 -4.02089 -36.565 -145 4 44.8236 41.822 33.2847 -5.06735 25.2561 -15.1823 -146 4 44.8583 1.80877 33.1923 -14.5958 -31.7921 -4.90526 -147 1 41.5264 5.19611 34.9737 -24.8334 44.6246 6.63495 -148 2 40.6685 6.33721 35.2699 -7.96634 19.3021 -16.1623 -149 2 41.3876 7.74941 35.097 -11.5591 -21.8484 1.81155 -150 3 40.7047 8.75309 34.8417 -6.4948 4.14558 0.128999 -151 4 41.7654 4.68652 35.8013 13.1043 -20.8107 18.8359 -152 4 39.8731 6.44712 34.4383 10.8594 -11.0445 14.3032 -153 2 39.8592 6.12601 36.6093 -15.5564 -7.24317 -37.5678 -154 3 40.7443 5.88444 37.6633 23.6025 16.5055 19.3857 -155 2 38.9047 4.85477 36.5395 -12.0583 61.1722 12.675 -156 4 39.322 7.07341 36.7706 -11.99 4.52079 9.89046 -157 4 41.1265 6.74598 37.8781 -3.93551 -10.4676 -4.79928 -158 4 38.0585 4.98564 35.7954 18.0693 -6.53498 -0.435941 -159 4 38.3566 4.77654 37.5171 8.14363 -6.92414 -3.72239 -160 4 39.543 3.99696 36.3828 0.165947 -30.6128 -6.86199 -161 1 42.7342 7.80416 35.136 -13.9315 11.8694 11.7976 -162 2 43.5142 9.02936 34.9481 17.7181 -46.9691 35.2138 -163 2 44.5073 9.42999 36.0349 -55.8537 -50.7646 50.0035 -164 3 45.375 10.2125 35.7599 43.422 25.9365 -4.74067 -165 4 43.1984 6.94617 35.4338 19.599 0.647333 4.29925 -166 4 44.1406 8.86955 34.0842 9.16679 3.97336 -28.1373 -167 4 42.9197 9.91228 34.8204 -18.5221 19.1219 -12.9063 -168 1 44.2798 8.93745 37.3587 -4.0043 10.1489 -58.0949 -169 2 45.1948 9.27519 38.4238 -4.17993 36.3676 -26.0855 -170 2 46.5575 8.73344 38.0061 12.5522 -20.4469 18.6928 -171 3 46.7331 7.49794 37.7681 -6.88831 31.8582 -6.20611 -172 4 43.377 8.45873 37.5311 9.37776 2.67644 11.4724 -173 4 45.2318 10.4158 38.3238 5.33405 -13.6354 14.6161 -174 2 44.7823 8.84756 39.8415 35.39 -32.4267 -9.44324 -175 2 45.5211 9.64049 40.9405 -33.0234 -16.4934 27.578 -176 2 45.0293 11.1067 41.0295 26.955 13.1382 1.75579 -177 2 45.9939 11.883 0.056845 5.44769 -3.52142 -7.77113 -178 1 45.567 13.2463 0.389189 -21.8942 22.5552 58.7427 -179 4 44.9649 7.71121 39.9163 -1.68078 22.7299 4.94117 -180 4 43.7292 8.96914 40.0006 -34.3585 3.91778 0.788359 -181 4 46.6326 9.56148 40.8729 -4.12637 -0.755434 -1.7729 -182 4 45.1589 9.15652 0.052119 21.5355 9.01144 -26.2886 -183 4 44.0384 11.1525 41.4882 -17.6691 -1.8484 1.78047 -184 4 44.9645 11.6456 40.0488 1.32443 -5.52779 3.51863 -185 4 46.9936 12.0079 41.4163 -11.0521 -7.71607 17.8496 -186 4 46.0863 11.2417 1.01939 6.64185 25.7549 -16.0759 -187 4 45.6176 13.9315 41.5535 6.39074 -1.54943 -2.93714 -188 4 46.1207 13.6426 1.21669 -15.3499 -18.2055 -38.2327 -189 4 44.572 13.3465 0.725918 28.6554 -12.4083 -12.8179 -190 1 47.5723 9.62675 38.0225 1.62241 16.525 -13.2778 -191 2 48.9413 9.31976 37.6447 28.3505 6.17866 3.85392 -192 2 49.7947 9.65595 38.897 -51.2415 76.6103 -24.0977 -193 3 49.6063 10.7902 39.4401 12.9093 -42.4425 -12.577 -194 4 47.4538 10.6389 38.3066 -1.81401 -22.4625 -4.08398 -195 4 49.0905 8.23756 37.4201 -8.03606 -0.867672 -0.903629 -196 2 49.3577 10.1392 36.3514 -15.5639 -8.86216 -34.5575 -197 3 48.3381 9.84531 35.2995 20.2521 4.60838 26.9691 -198 2 50.6821 9.73379 35.6575 -13.1705 -1.52152 26.2758 -199 4 49.443 11.2403 36.5183 -14.2645 -0.263993 8.70321 -200 4 47.5106 10.2398 35.5579 0.218555 2.62212 3.26783 -201 4 50.9323 10.3465 34.7687 -2.88514 -3.55444 -7.60949 -202 4 50.7732 8.65192 35.4951 -3.14548 -9.24106 -12.1943 -203 4 51.4763 9.94768 36.3674 17.1427 5.0591 10.0517 -204 1 50.5022 8.69828 39.4305 24.0939 -43.466 77.1583 -205 2 51.0483 8.71922 40.8082 -0.802123 10.2433 -32.8315 -206 2 52.5183 8.33859 40.7231 46.1376 25.1574 58.8821 -207 3 52.8914 7.33748 40.1143 13.0446 10.4001 -14.6089 -208 4 50.6189 7.73433 39.1341 -5.48208 -8.91176 -29.3848 -209 4 51.0045 9.75097 41.1725 -0.547397 17.2241 4.09797 -210 2 50.2922 7.85282 41.8455 19.6626 -50.7873 -7.63422 -211 2 50.2811 6.29504 41.471 -17.2864 -17.6708 26.7503 -212 2 48.8668 8.31684 0.212195 -17.3783 63.506 12.4232 -213 2 49.3691 5.38294 0.512646 14.3884 65.6628 -4.02696 -214 4 50.9326 7.9114 0.860642 -12.3241 5.1929 3.57402 -215 4 51.3127 5.83882 41.5287 -4.74499 10.5855 -5.5164 -216 4 49.8921 6.13652 40.4532 1.6457 0.843055 -11.9856 -217 4 48.0317 8.06123 41.424 13.0217 -7.20036 -2.54126 -218 4 48.8693 9.49201 0.254246 -0.917701 -32.4673 -2.46528 -219 4 48.5263 8.05212 1.23597 1.41612 -6.96817 -0.649274 -220 4 48.2816 5.57755 0.309314 6.34191 -1.32326 5.14384 -221 4 49.6363 5.72968 1.56057 -11.1106 -15.1353 -5.99489 -222 4 49.54 4.32324 0.397743 7.27301 -24.1582 -2.3836 -223 1 53.3925 9.14738 41.5454 -19.7766 -15.6836 -47.6014 -224 2 54.8543 9.29866 41.641 -12.5045 -20.0873 29.727 -225 2 0.407838 8.25913 0.762984 -29.7207 32.5524 -37.8245 -226 3 54.8643 8.2564 1.86493 17.0269 -29.0845 20.332 -227 4 52.9285 9.69819 0.341812 -9.11605 14.2566 13.2302 -228 4 0.291486 9.0623 40.6877 9.99865 -5.39191 -34.8298 -229 2 0.359683 10.7121 0.203065 -6.90664 -3.88067 -14.6485 -230 3 54.4765 11.8025 41.752 -11.2022 -21.2627 -5.88002 -231 2 1.6614 11.1001 41.4135 2.5167 -27.9916 -13.3179 -232 4 0.487415 10.6137 1.28953 0.410521 18.1219 13.0764 -233 4 54.0953 12.1937 0.613553 1.59003 1.59721 11.7532 -234 4 1.92456 12.0955 41.7398 14.8193 23.7252 4.53742 -235 4 1.52762 11.126 40.2979 3.61624 1.93597 7.36374 -236 4 2.5241 10.4069 41.6364 -8.38015 7.04993 1.52106 -237 1 1.45864 7.53391 0.367476 0.545631 9.71791 -21.8799 -238 2 2.25081 6.65311 1.15507 26.446 -0.0641839 -18.4938 -239 2 3.7671 6.96757 0.917085 -57.4365 -22.4689 85.9929 -240 3 4.15047 7.41488 41.7757 21.4144 12.1214 -29.7802 -241 4 1.8001 7.62601 41.3064 3.76941 -0.348546 3.21752 -242 4 1.98413 6.84865 2.19976 1.77378 -4.57114 13.3572 -243 2 1.98593 5.20856 0.673411 -39.0557 8.05152 -2.47083 -244 2 0.499001 4.77546 0.950638 51.92 -35.3278 3.54994 -245 2 0.302449 3.38226 0.307039 12.2804 5.92691 27.6936 -246 2 0.318833 4.59091 2.46762 -57.1886 17.9845 23.4913 -247 4 2.62035 4.47984 1.15306 24.0478 -12.5257 10.4353 -248 4 2.17019 5.14075 41.4887 6.74012 -0.473312 -2.7006 -249 4 54.8482 5.46061 0.448133 -33.0903 28.7369 -7.07308 -250 4 54.2241 3.15851 0.337643 -14.6094 -12.7265 -2.24176 -251 4 0.881511 2.58656 0.876485 -8.96903 11.0382 -11.5819 -252 4 0.635114 3.38296 41.1822 2.70741 -4.49002 -20.1461 -253 4 0.991181 3.80938 2.86091 2.53728 -4.51346 7.06316 -254 4 54.1796 4.30541 2.72425 38.6722 3.44969 -10.622 -255 4 0.495432 5.52724 3.08531 2.73328 -11.7655 -13.2166 -256 1 4.49387 6.66874 2.05101 59.25 35.5651 -63.8633 -257 2 5.97745 6.82619 2.08157 -13.5783 -40.6566 -15.6714 -258 2 6.57448 5.47381 2.54294 67.6927 12.9151 50.3283 -259 3 7.53922 5.43765 3.33186 -5.78511 6.85237 -12.8739 -260 4 4.10191 6.33546 2.9164 -11.2688 -10.0369 11.6191 -261 4 6.35409 6.85375 1.02753 1.73229 12.3732 3.55997 -262 2 6.47001 8.00523 2.96248 -35.1701 -2.47648 -9.01657 -263 2 6.52316 9.38515 2.26526 -52.089 -36.3571 -52.5381 -264 2 6.66039 10.5311 3.17647 23.2175 30.5211 32.7092 -265 3 7.81872 10.9467 3.49478 5.10838 -9.19539 -6.96115 -266 3 5.64173 11.0573 3.6767 -20.5888 -1.64097 0.158765 -267 4 7.42654 7.87231 3.41702 35.4584 -16.2138 5.63399 -268 4 5.81838 7.86205 3.84167 -4.54492 27.3919 10.2645 -269 4 5.56237 9.49095 1.59664 20.5708 1.89307 25.306 -270 4 7.29681 9.38215 1.47849 13.2355 1.21078 1.19218 -271 1 6.08096 4.31767 2.17259 -39.414 -15.8224 -24.7678 -272 2 6.39518 2.91476 2.36043 4.12081 37.0723 19.1814 -273 2 7.75633 2.62628 1.79624 63.8838 -9.4865 -25.3011 -274 3 8.33634 3.36937 0.946953 -27.4154 -16.213 26.3787 -275 4 5.28658 4.43126 1.58002 -24.0887 -1.16266 -20.2566 -276 4 6.54455 2.77577 3.45017 -8.86613 -5.70482 8.60941 -277 2 5.25427 2.02933 1.82805 -30.6144 -48.6247 5.61864 -278 2 3.85552 2.1153 2.66383 78.486 27.413 32.1434 -279 2 4.87851 2.27508 0.297641 -10.4566 -15.7718 22.2154 -280 4 5.65998 0.937168 1.99721 -15.6319 23.5495 -14.0675 -281 4 3.98898 1.63213 3.72107 -1.04911 23.3354 -24.3429 -282 4 3.15409 1.48884 2.20213 -45.477 -24.0418 -26.2275 -283 4 3.51802 3.20813 2.70746 -2.40249 -20.6527 6.6832 -284 4 4.39172 3.24426 0.119355 -1.44384 9.21297 0.0772101 -285 4 4.19746 1.51559 41.6955 12.4172 8.09212 16.5491 -286 4 5.82002 2.28129 41.6778 17.5327 1.3005 -22.4945 -287 1 8.43941 1.53208 2.30673 1.7292 42.4201 -39.4356 -288 2 9.76672 1.10452 1.81012 11.995 -19.5667 23.3003 -289 2 9.60964 41.7637 0.921245 4.05677 21.7498 -11.1929 -290 3 8.59567 41.087 1.06007 7.18507 -15.5872 -8.58634 -291 4 7.90606 0.81761 2.76924 -8.42032 -19.931 16.3865 -292 4 10.4026 1.87877 1.34085 -18.5158 15.1062 -12.7744 -293 2 10.6232 0.647963 3.0246 -34.7832 -39.5023 14.4787 -294 2 11.0993 1.6812 4.04079 16.2934 16.5377 23.708 -295 2 12.4719 2.27616 3.59128 -46.8378 -2.52013 6.7155 -296 3 13.4675 1.63575 4.02276 22.0629 14.477 -13.463 -297 3 12.4471 3.24187 2.73298 15.8946 -22.2661 28.0778 -298 4 11.4641 0.045385 2.63277 10.8271 5.92943 5.75519 -299 4 10.0353 41.7446 3.607 8.35649 20.5438 -12.0897 -300 4 11.2832 1.11765 5.0427 -4.51453 13.9694 -21.6118 -301 4 10.341 2.4932 4.3105 9.65416 -13.2167 -8.7997 -302 1 10.6494 41.4676 0.039711 8.78515 0.440053 18.9323 -303 2 10.7217 40.2184 41.1909 10.2574 -28.5822 12.1248 -304 2 10.6889 38.8907 0.171469 -17.3791 70.2346 -13.2363 -305 3 10.1368 37.8928 41.652 0.864281 -20.5458 12.6113 -306 4 9.82473 40.2067 40.5786 -14.2689 -8.84554 -18.4029 -307 2 12.0478 40.1799 40.3262 -31.3786 20.6535 10.6233 -308 2 12.4388 41.6551 40.4794 16.223 20.8678 -10.392 -309 2 11.8805 0.34241 41.7792 -28.1233 -36.7072 -34.4959 -310 4 11.9102 39.8982 39.2292 -1.08614 0.893428 17.4874 -311 4 12.7409 39.4563 40.8087 9.93344 3.46544 -3.32375 -312 4 12.0845 0.391154 39.5895 8.62314 -16.2997 14.2071 -313 4 13.5502 41.7447 40.5643 -1.70925 0.910467 -12.4735 -314 4 11.7305 1.40344 41.6414 -9.5626 24.5309 -2.35213 -315 4 12.5687 0.26268 0.684216 19.8182 -9.73862 27.9097 -316 1 11.1854 39.0885 1.40191 34.1901 -11.3327 18.3686 -317 2 11.4785 38.09 2.41707 -37.5808 13.2867 4.32174 -318 2 10.2405 37.7763 3.3402 -0.155099 -13.1844 6.87934 -319 3 10.4378 36.9653 4.27207 -11.6928 9.67513 -22.7546 -320 4 11.6756 39.9703 1.62918 -8.97807 -2.58442 -2.36164 -321 4 11.7153 37.147 1.89269 -3.37493 -11.1801 -2.58831 -322 2 12.7263 38.4682 3.25859 -32.7454 -15.529 27.3397 -323 3 12.5885 39.7408 3.87129 1.54426 18.5893 -11.5354 -324 4 13.5945 38.4441 2.61946 23.9879 5.88222 -14.7576 -325 4 12.9197 37.685 4.04183 -3.566 10.9198 -2.82194 -326 4 11.9285 39.8531 4.57214 8.5625 -16.1459 -5.7164 -327 1 8.98961 38.3717 3.14779 19.3135 28.1448 -76.0315 -328 2 7.78009 38.1002 3.90315 -4.26896 22.0341 0.229441 -329 2 6.83069 37.1869 3.18241 -25.8564 -25.3069 -16.1867 -330 3 6.84398 36.9785 1.97125 20.9058 23.903 -13.4458 -331 4 8.79049 38.9506 2.20714 10.5577 -30.8167 54.9659 -332 4 8.11274 37.5073 4.75427 1.14536 -6.32615 23.8911 -333 2 7.0077 39.4163 4.32571 4.21253 -4.87986 18.678 -334 2 7.75781 40.1168 5.42156 46.58 -14.1846 12.934 -335 3 8.30143 41.2262 5.21331 -14.6188 11.6514 -5.86083 -336 3 8.10545 39.4797 6.46784 -18.045 3.20128 -4.6129 -337 4 6.01572 39.173 4.78754 -1.72287 0.045533 -10.2864 -338 4 6.87032 40.2048 3.55457 -4.98407 -10.6589 -12.5629 -339 1 5.91154 36.4899 3.88964 18.6928 -0.691686 25.3425 -340 2 4.98537 35.571 3.20749 -24.0931 31.8814 30.8723 -341 2 3.79198 36.4499 2.67545 58.5623 50.3783 54.6165 -342 3 3.60244 37.6478 3.05835 4.98938 -42.2114 -12.2812 -343 4 5.945 36.5545 4.93654 -10.5756 -4.83423 -16.3239 -344 4 5.5221 35.038 2.40161 -3.05594 2.46612 -11.4716 -345 2 4.40384 34.4728 4.15145 -1.70261 45.9252 5.92389 -346 3 3.98498 35.0725 5.41787 -8.00202 -46.5665 -16.5053 -347 2 5.48475 33.4747 4.46048 0.249803 -29.9924 71.6177 -348 4 3.54337 34.0389 3.61058 -6.82183 -12.9435 7.69028 -349 4 3.62675 34.2747 5.86698 6.39679 27.749 2.05336 -350 4 5.85279 32.9868 3.57629 11.3184 -16.9973 -22.3871 -351 4 5.09248 32.6743 5.23041 8.97186 17.4623 -32.7541 -352 4 6.34746 33.9006 5.03324 -0.476546 4.78606 -11.5797 -353 1 3.00152 35.8184 1.87366 -46.1462 -42.5584 -55.0681 -354 2 1.77021 36.3468 1.35692 -36.7765 14.163 11.1031 -355 2 0.721356 36.5788 2.57059 18.2386 -29.7925 23.2574 -356 3 54.9678 37.5551 2.63992 10.9193 3.0322 -8.68025 -357 4 3.31287 34.9586 1.40066 1.19836 -3.77239 4.28893 -358 4 2.05059 37.3327 0.922928 -11.4048 10.7741 9.22697 -359 2 1.07197 35.5705 0.158527 41.3495 -39.9506 -9.05678 -360 2 1.73776 35.9497 40.6674 -26.4234 39.8053 33.0301 -361 2 54.5322 35.7209 0.133627 -14.8072 -12.0564 -1.20894 -362 2 3.23928 35.9487 40.63 7.11928 -24.1756 -12.68 -363 4 1.32474 34.4514 0.269568 -7.211 20.0201 5.35532 -364 4 1.47926 37.0502 40.6385 -3.87579 -7.90549 -26.2729 -365 4 1.36122 35.3789 39.7771 -4.72819 3.84386 12.155 -366 4 54.087 35.0558 41.2526 3.68912 7.63158 3.17282 -367 4 54.2076 36.7772 41.8385 0.949253 -6.55132 4.09096 -368 4 54.0676 35.3362 1.10912 4.22691 12.456 -17.368 -369 4 3.57003 34.9443 40.8434 9.13412 -24.8126 8.40569 -370 4 3.78301 36.5792 41.3142 5.34684 18.5101 18.1918 -371 4 3.6567 36.127 39.6372 -0.20476 7.44967 -14.9904 -372 1 0.712989 35.6055 3.58431 38.0557 9.26554 -59.6495 -373 2 0.05279 35.6483 4.83915 -15.0961 2.42646 38.658 -374 2 0.191347 37.0144 5.48801 7.00468 33.8104 1.40802 -375 3 54.154 37.7008 5.76148 35.4113 -11.6645 -8.2681 -376 4 1.23482 34.733 3.35856 -11.2418 4.01634 10.8504 -377 4 53.9671 35.581 4.69172 -20.2496 -5.13772 -12.456 -378 2 0.463881 34.4895 5.81355 17.031 15.9659 -33.5139 -379 2 54.8083 34.3393 7.16558 -30.7527 -16.2072 -11.1445 -380 2 0.00712 35.4957 8.10271 3.59003 -8.69902 15.3198 -381 3 54.0967 36.3529 8.34542 -1.77732 -9.94333 -12.6544 -382 3 1.07192 35.4587 8.7399 35.3598 16.353 18.5034 -383 4 1.56574 34.5304 5.94519 0.590681 0.639559 4.32925 -384 4 0.280894 33.5741 5.23349 -1.52963 -16.3279 0.16603 -385 4 0.223173 33.3947 7.64873 -6.8885 8.42796 -3.46601 -386 4 53.7112 34.1554 6.97481 9.65493 -2.46487 7.60139 -387 1 1.50649 37.4152 5.65526 -22.458 -31.2308 -17.0045 -388 2 2.02438 38.6379 6.15097 -3.22056 29.1656 36.4104 -389 2 1.58588 39.8651 5.40701 -13.5031 20.9194 -76.104 -390 3 1.07209 40.8553 5.93778 8.03965 -15.1327 11.1864 -391 4 2.24702 36.741 5.38136 -6.00826 1.88497 2.51587 -392 4 1.72629 38.833 7.20228 -22.1923 -11.9073 0.0585309 -393 2 3.51949 38.6121 6.24971 43.6984 -50.5664 -0.0787057 -394 2 4.11017 39.7004 7.10642 -5.48661 12.2779 -12.8977 -395 3 4.55887 40.7033 6.57435 6.12607 11.2234 -5.55098 -396 1 3.97545 39.5562 8.42942 -13.6958 7.00999 41.6346 -397 4 3.92653 38.5973 5.19958 6.67843 9.43594 11.2804 -398 4 3.90699 37.6191 6.72902 -10.8805 23.4385 -12.7616 -399 4 3.35162 38.8096 8.83526 13.2612 9.60447 -6.60232 -400 4 4.25023 40.3377 9.09595 -2.56729 -20.1743 -21.9158 -401 1 1.64621 39.8034 3.99517 -50.1719 52.4074 67.8966 -402 2 0.960547 40.8538 3.14427 -3.37695 -31.9032 -17.009 -403 2 54.4047 41.0035 3.47138 71.1401 19.2662 2.3079 -404 3 53.9887 0.221409 3.63964 -22.8765 18.4333 9.81455 -405 4 2.07659 38.9926 3.63308 18.9969 -31.9912 -34.7926 -406 4 1.39808 41.8727 3.34889 0.835518 -9.01277 1.27119 -407 2 1.14841 40.4887 1.56595 -9.49555 20.2148 39.7014 -408 2 0.469253 41.6189 0.677094 10.8075 11.2475 47.495 -409 2 2.6528 40.4777 1.25625 -15.459 -47.3647 -39.6369 -410 4 0.776571 39.4398 1.40308 -11.1955 11.1351 -6.38222 -411 4 54.3852 41.8501 0.825468 -5.0709 -17.7069 -2.05205 -412 4 0.696071 41.5065 41.5456 0.0730393 -4.82529 -32.9133 -413 4 0.904174 0.691668 0.985463 6.30616 -9.41897 -5.2369 -414 4 2.64269 40.3122 0.13166 16.7998 18.1471 15.5753 -415 4 3.13789 39.5289 1.58622 -1.56816 4.1145 9.56394 -416 4 3.29805 41.2779 1.59825 6.1243 20.9887 1.16769 -417 1 53.684 39.9214 3.65257 -36.1976 13.6917 8.19643 -418 2 52.3006 39.9493 4.06589 -56.8626 -17.5359 -10.0305 -419 2 52.042 40.5256 5.46425 9.62461 10.2848 -5.14962 -420 3 51.0331 41.2228 5.70144 14.4944 -11.372 -4.23176 -421 4 54.0189 39.0607 3.30247 15.8062 -40.5534 -6.95561 -422 4 51.6931 40.6476 3.38276 19.0563 -8.07776 7.22418 -423 2 51.5622 38.4976 3.96193 14.5706 2.1127 21.5154 -424 2 51.4158 37.9814 2.50572 24.752 -20.928 -15.9835 -425 2 51.0077 36.4305 2.37064 11.3099 30.9145 9.08043 -426 2 50.8522 35.9939 0.907307 -46.4939 -7.09254 -49.7464 -427 1 50.1475 34.7025 0.671588 69.6077 -32.405 2.84717 -428 4 50.6006 38.4842 4.55016 3.73478 6.81079 -18.2086 -429 4 52.1831 37.7463 4.55262 -3.81101 12.3643 -13.1539 -430 4 52.4118 38.1657 2.02278 1.77015 -18.5404 7.48984 -431 4 50.8584 38.5927 1.79489 -26.3581 9.74254 8.34414 -432 4 50.0453 36.2246 2.88499 -2.56193 3.57961 3.68626 -433 4 51.7703 35.8375 2.92238 0.215708 -6.73604 -5.33103 -434 4 51.7691 36.0437 0.240386 -6.2594 -4.10885 19.6388 -435 4 50.1039 36.686 0.3716 22.9763 1.60597 16.3794 -436 4 50.5914 33.8993 1.10828 2.95648 12.8391 18.7814 -437 4 50.3001 34.3737 41.6268 -19.3387 19.3411 -4.27099 -438 4 49.2006 34.6111 0.961468 -24.084 7.88088 -0.582308 -439 1 53.0235 40.2561 6.35237 -32.3128 10.4579 -5.0201 -440 2 53.1129 40.7256 7.70074 -41.6363 -1.15369 57.3167 -441 2 53.1798 0.352689 7.77253 -34.9991 -20.8035 37.2736 -442 3 52.5119 1.01286 8.63006 21.7579 -17.6925 -30.8538 -443 4 53.6931 39.5673 6.06584 22.7894 -18.2937 1.39271 -444 4 52.0865 40.4844 8.3065 35.7608 3.68212 -29.1988 -445 2 54.2701 40.0034 8.46069 6.08948 28.5921 -6.02695 -446 4 54.5971 40.5153 9.39975 -22.234 -14.34 10.1754 -447 4 0.201561 40.2092 7.93116 13.6903 -2.08726 -21.3806 -448 4 54.1655 38.8939 8.41526 -0.559105 0.118215 15.5404 -449 1 53.9752 0.884949 6.87383 32.3465 35.364 -24.1241 -450 2 54.062 2.35993 6.75215 -1.13821 -0.709889 -34.8218 -451 2 52.7471 3.02097 6.14186 4.92946 35.4069 59.7439 -452 3 52.3227 4.16587 6.4978 18.9545 -33.4145 3.00952 -453 4 54.7345 0.266534 6.4753 -18.8262 24.4346 -1.05702 -454 4 54.2802 2.76759 7.79054 -12.1814 3.84369 -14.3249 -455 2 0.185451 2.81859 5.73187 27.2059 46.9588 30.4236 -456 2 1.71808 2.36893 6.1571 -63.9259 -20.0653 -29.4315 -457 2 1.9764 2.63004 7.63437 43.6306 13.7343 2.97159 -458 2 3.27263 1.81187 8.04275 -33.9139 -3.58936 -6.58926 -459 1 3.78328 2.11956 9.34176 26.6398 21.4152 24.507 -460 4 0.173809 4.01773 5.82442 4.54198 -39.0295 -6.50933 -461 4 54.8792 2.64498 4.65574 11.0791 -10.5686 10.592 -462 4 2.43618 2.90609 5.45978 -2.35628 -10.1976 10.4282 -463 4 1.76796 1.2289 6.01344 4.57023 21.5888 -8.89179 -464 4 1.21473 2.41369 8.37281 -19.449 -19.8593 5.28327 -465 4 2.02309 3.72579 7.75906 18.9296 5.96095 -1.30777 -466 4 4.11389 1.88412 7.33652 2.51142 0.584915 -8.00636 -467 4 2.91513 0.727469 8.06593 14.1612 11.4678 0.952909 -468 4 3.87966 1.33238 9.93849 2.65093 -23.7146 9.43734 -469 4 3.29203 2.7681 9.89323 -42.3935 13.6729 9.41431 -470 4 4.65765 2.6209 9.4154 12.4458 -11.5538 -21.8273 -471 1 52.0387 2.32512 5.28273 -51.3661 -11.8477 -11.6622 -472 2 50.6641 2.72274 4.84157 25.7857 6.93126 13.1254 -473 2 49.5414 2.57609 5.91007 27.6149 -7.37739 5.45836 -474 3 48.7805 3.52104 6.09585 -8.9672 -1.93713 4.87304 -475 4 52.4681 1.55108 4.79165 6.19099 -18.5603 -5.58783 -476 4 50.6769 3.82983 4.70864 1.41274 -1.50214 -10.3294 -477 2 50.3587 2.05695 3.49156 -22.4167 -18.5545 -8.10533 -478 2 51.392 2.35646 2.3419 -24.5199 12.8001 2.40788 -479 2 48.9327 2.41504 2.97856 -9.14079 -2.86031 26.3031 -480 2 51.1945 1.4129 1.15651 29.522 -13.6455 -15.5517 -481 4 50.3189 0.937191 3.7523 9.08136 15.4094 -11.3523 -482 4 52.3823 2.12188 2.68097 31.5971 -0.36407 15.4796 -483 4 51.4014 3.46798 2.06765 -1.078 -19.9026 -0.0406259 -484 4 48.2117 2.12758 3.78451 -1.04241 22.2186 2.00084 -485 4 48.5813 1.67256 2.28636 2.21501 -12.0529 -35.8697 -486 4 48.7327 3.44552 2.54328 5.48386 -12.5705 11.3103 -487 4 52.1623 1.3706 0.452926 -36.5132 5.61179 20.4585 -488 4 50.2881 1.70969 0.600596 -1.11419 -0.409473 -10.6314 -489 4 51.0211 0.353877 1.53511 3.53067 13.7442 -8.50616 -490 1 49.5623 1.51743 6.77214 29.0905 -0.0770965 -25.5222 -491 2 48.7084 1.41716 7.91723 -3.12505 -21.6463 4.96918 -492 2 48.8549 2.61932 8.82546 31.903 20.2748 29.0475 -493 3 47.906 3.05048 9.46897 -16.8524 2.35798 -10.3438 -494 4 50.2118 0.710522 6.59294 -12.9921 18.0739 4.61122 -495 4 47.6425 1.393 7.52359 9.91609 0.328738 10.372 -496 2 49.0787 0.089334 8.73016 -60.0302 -9.6098 -44.8862 -497 2 48.2852 41.7441 10.0242 3.18066 15.7764 -9.96769 -498 2 46.7826 0.060746 9.96682 -2.34726 -14.6607 41.7592 -499 3 46.2233 0.511631 10.9878 -5.96974 4.10403 -23.4495 -500 1 46.1388 41.3329 8.97776 32.9533 20.065 15.0282 -501 4 50.1182 0.035639 8.93296 42.8084 2.68407 12.3764 -502 4 48.8904 41.1121 8.0025 3.88899 17.9501 19.4277 -503 4 48.6104 0.602172 10.7954 4.73737 -18.8132 -0.914642 -504 4 48.4759 40.6816 10.3394 0.165969 9.19265 10.3013 -505 4 46.673 40.8953 8.25882 14.2049 -15.3063 -26.5369 -506 4 45.1569 41.364 8.91958 -49.0994 -2.53611 0.320683 -507 1 50.1114 3.13932 9.06291 -28.12 32.8195 0.337886 -508 2 50.3404 4.32895 9.98795 -1.65029 -57.226 -17.8628 -509 2 50.0322 5.66893 9.41362 -36.2334 -9.83443 -38.9072 -510 3 49.3598 6.44562 10.1062 15.3309 6.40082 -5.38514 -511 4 50.9085 2.84633 8.5071 12.3092 -10.0263 -3.45928 -512 4 49.5835 4.28149 10.7848 -3.38143 -13.253 14.1405 -513 2 51.7461 4.22789 10.5468 25.7206 14.4209 20.1557 -514 2 51.9023 5.17188 11.7283 -67.9962 -1.36338 64.1829 -515 3 50.9364 5.19004 12.6002 28.9599 1.18541 -41.9912 -516 3 52.9319 5.83594 11.9785 18.8411 2.87417 -24.5577 -517 4 52.4276 4.5214 9.72474 12.6887 -3.13287 0.413374 -518 4 52.058 3.21563 10.9647 -9.24198 7.66389 -16.6414 -519 1 50.112 5.78532 8.03139 7.52033 29.602 25.459 -520 2 49.6799 7.08933 7.40639 14.3534 -30.8181 22.5674 -521 2 48.2409 7.17209 6.9711 -2.24553 44.7474 7.57528 -522 3 47.5844 8.22961 7.08968 18.1939 -9.81929 5.41459 -523 4 50.7064 5.09112 7.53173 -12.638 14.3936 -6.22521 -524 4 49.7159 7.84119 8.19837 -7.36252 7.51614 21.2329 -525 2 50.7023 7.64954 6.44039 -16.0213 -40.4967 -48.4302 -526 2 50.7257 6.82423 5.08423 -13.7427 47.9405 2.4816 -527 2 51.6418 7.28287 3.94021 29.8472 39.248 73.299 -528 2 53.127 6.98483 4.24688 1.29977 19.7271 -18.9866 -529 1 53.757 7.95176 5.17575 -11.1866 13.844 -62.5277 -530 4 51.636 7.68275 6.97838 28.3767 1.23741 1.58475 -531 4 50.4129 8.66535 6.18803 -0.179632 23.7408 -3.11047 -532 4 49.7187 7.01043 4.64523 -5.97611 -10.1095 1.48316 -533 4 50.8061 5.7562 5.2149 3.4405 -22.8364 10.0865 -534 4 51.5118 8.41472 3.72654 -1.36136 -26.6124 -3.74792 -535 4 51.4228 6.66542 3.12568 -20.7249 -22.8033 -58.4365 -536 4 53.6095 7.03345 3.2004 3.85152 5.93338 28.8514 -537 4 53.3314 5.96083 4.57939 -0.112253 -9.13532 8.29834 -538 4 53.309 8.86524 5.1699 0.162268 -2.42959 1.84412 -539 4 54.6672 8.17057 4.81193 19.2107 -0.812718 7.6593 -540 4 53.869 7.69009 6.11536 0.991087 -15.435 33.6166 -541 1 47.7293 6.1299 6.36528 -13.6545 -50.1986 -45.913 -542 2 46.4151 6.11998 5.73127 12.5517 -4.35851 26.1033 -543 2 45.4457 5.24236 6.50095 -54.5114 -4.35957 -22.3583 -544 3 44.2134 5.34166 6.22856 33.5613 3.36987 15.344 -545 4 48.2957 5.29705 6.08439 -4.65701 16.0313 11.2062 -546 4 46.0246 7.14829 5.83676 -12.413 4.85954 -1.2939 -547 2 46.3966 5.7006 4.23247 16.9743 -35.0719 19.3242 -548 2 46.8471 6.79722 3.31369 7.95245 13.9142 -51.9109 -549 2 46.0679 8.12855 3.29075 19.7668 12.2354 20.4517 -550 3 44.9703 8.28242 2.6836 -5.20426 -7.76074 -7.99938 -551 3 46.5716 9.08042 3.9624 -5.49585 -3.27174 -8.75295 -552 4 45.3525 5.37075 3.98324 7.30106 1.55378 -6.68576 -553 4 47.1483 4.79199 4.10624 -28.8106 21.423 0.303262 -554 4 47.0017 6.41037 2.24023 -12.0684 6.13088 18.9752 -555 4 47.8815 7.05675 3.60692 6.175 4.12296 2.89493 -556 1 45.8802 4.28795 7.34048 -32.7588 9.8199 -6.22093 -557 2 44.9801 3.41661 8.05582 7.11941 -0.762777 6.83491 -558 2 44.2841 2.32798 7.24802 57.2007 25.2815 -35.4523 -559 3 43.4338 1.62321 7.71908 -38.784 -24.7635 26.1598 -560 4 46.8556 4.13399 7.46211 34.7056 -9.13536 7.69054 -561 4 45.5867 2.90913 8.82837 -2.10841 -5.06197 5.41207 -562 4 44.2233 4.00883 8.63057 1.71074 -0.990438 -6.10924 -563 1 44.7516 2.08483 5.98824 -37.8462 -38.4135 -8.16449 -564 2 44.1597 1.01431 5.13579 -9.65639 -34.378 14.28 -565 2 44.8664 41.5016 5.49089 -11.1964 37.9598 3.64882 -566 3 46.103 41.4369 5.57345 -11.1149 2.47206 2.88353 -567 4 45.5262 2.474 5.47152 21.0389 22.2918 12.8005 -568 4 43.0172 0.862184 5.40503 31.5022 14.6416 -15.142 -569 2 44.4162 1.4085 3.60515 5.8653 -21.2021 14.2009 -570 2 43.5161 2.65984 3.27425 41.0117 -18.0627 24.5931 -571 2 44.2213 0.116838 2.67583 -30.001 3.65408 12.6342 -572 2 43.604 3.10049 1.82796 -41.0466 14.5447 22.3036 -573 4 45.4923 1.71966 3.57573 -0.138156 -3.02814 -11.6903 -574 4 43.8008 3.50537 3.97163 -2.46499 -4.10631 -11.566 -575 4 42.524 2.38704 3.60859 -29.3388 -0.685173 -5.23931 -576 4 44.5714 0.285197 1.65031 -2.2735 9.46305 -11.1841 -577 4 43.1006 41.7553 2.65834 21.2852 6.7215 -5.00379 -578 4 44.7366 41.0658 2.93547 0.768749 11.7185 9.28335 -579 4 44.5004 3.68719 1.60884 14.6444 -0.878149 -7.94907 -580 4 42.7371 3.8089 1.73084 7.8177 -0.664582 -10.9353 -581 4 43.3892 2.25631 1.16493 5.07933 -5.28874 -15.8541 -582 1 44.0858 40.4147 5.76991 -7.82686 10.7063 0.0613705 -583 2 44.6952 39.2248 6.26612 46.8291 -49.1328 2.55503 -584 2 45.6273 38.4983 5.15014 -10.8203 -24.5871 -10.3389 -585 3 45.1671 38.1033 4.04814 1.93862 22.6196 32.2907 -586 4 45.3114 39.4262 7.20071 -5.62912 7.00222 -16.0196 -587 2 43.5561 38.2867 6.74046 -22.632 -0.869913 -14.9675 -588 2 42.367 38.8131 5.80069 8.99216 14.1028 58.1483 -589 2 42.6345 40.3137 5.92605 0.476166 33.3948 28.8915 -590 4 43.357 38.4284 7.8368 -6.62566 13.9326 -12.0425 -591 4 43.8048 37.1922 6.7609 -3.60965 9.48681 -21.6917 -592 4 41.3136 38.6254 6.13023 8.266 -9.51845 1.65532 -593 4 42.4187 38.6156 4.74928 6.70678 -23.3061 -29.6074 -594 4 42.2773 40.816 6.98347 15.1971 -23.3227 -46.4987 -595 4 42.1119 40.8277 5.08767 -3.55372 4.4917 2.49103 -596 1 46.8487 37.9967 5.55394 17.2019 12.2692 25.006 -597 2 47.7247 37.0178 4.87762 -6.21972 -16.2302 -28.9734 -598 2 47.0354 35.8358 4.10675 -5.54108 30.4574 49.2069 -599 3 47.4638 35.4602 3.01706 -3.2731 6.26074 0.626287 -600 4 48.411 37.4477 4.12082 -11.0175 18.1135 -5.68521 -601 2 48.6499 36.5231 5.98749 -16.6595 -15.0747 15.7963 -602 2 48.891 37.7945 6.79307 0.637735 -25.9659 35.4869 -603 2 47.512 38.4108 6.81936 -6.06228 0.364124 -35.7901 -604 4 49.55 36.0027 5.64818 14.2665 0.926908 -8.4052 -605 4 48.1323 35.7432 6.6035 -1.04051 5.39171 0.916503 -606 4 49.6303 38.4539 6.33816 11.9938 9.28906 -4.17289 -607 4 49.2156 37.5316 7.87598 -0.828426 8.45001 -24.626 -608 4 47.6223 39.5002 6.92189 -5.61966 10.135 -2.25063 -609 4 46.9349 38.0418 7.65693 -11.0214 -6.34351 22.8142 -610 1 45.9811 35.3016 4.79343 19.1712 31.3513 11.165 -611 2 45.3118 34.1769 4.28537 -21.2148 -46.3229 -17.5718 -612 2 44.4751 34.4561 3.06273 -18.3812 8.00009 -33.6438 -613 3 44.391 33.6426 2.09905 3.94034 16.0457 30.0851 -614 4 45.6176 35.6832 5.71813 13.2063 -8.66839 -22.6288 -615 4 46.0373 33.4799 3.80083 11.0255 -0.404913 12.3267 -616 2 44.604 33.4055 5.40679 37.9095 -5.49339 -20.8443 -617 2 43.894 32.1911 4.95963 4.52806 -52.0805 -10.2655 -618 3 42.6666 32.0496 5.30411 26.1406 -7.63566 -17.5185 -619 3 44.6473 31.2926 4.419 -30.7677 19.4747 14.2469 -620 4 43.8381 33.9821 5.82617 -35.1808 40.951 30.2942 -621 4 45.3664 33.1691 6.19311 -10.275 -1.0365 4.4818 -622 1 43.9409 35.7078 2.94042 3.22733 -51.5357 -49.9186 -623 2 43.348 36.2006 1.70588 25.8776 -9.12573 -18.8138 -624 2 44.3757 36.8172 0.713167 -7.64912 -13.2689 38.6134 -625 3 44.0628 36.9589 41.4508 -2.41529 3.02373 -15.0868 -626 4 43.9087 36.323 3.69682 4.46748 41.5024 48.5675 -627 4 43.0059 35.3045 1.0879 -7.34341 13.0696 15.3539 -628 2 42.2218 37.2049 1.98307 -32.8685 -0.904888 11.5727 -629 2 41.1062 36.5938 2.90711 22.5622 20.6064 -2.77479 -630 2 39.8757 37.4913 2.92488 9.99264 -5.47282 62.3883 -631 3 39.5847 37.9927 4.02645 -6.88693 1.84466 -13.34 -632 1 39.0832 37.5519 1.86835 -2.09978 -20.426 -31.5908 -633 4 41.7044 37.4782 1.02484 10.2081 4.13789 1.30545 -634 4 42.5649 38.1527 2.49808 3.34998 -7.04672 -12.996 -635 4 41.496 36.4873 3.97615 -8.32458 2.86238 -16.0656 -636 4 40.817 35.592 2.59085 -6.50381 -15.3028 -7.15704 -637 4 39.3467 37.1489 0.943045 -1.18671 2.30285 11.2704 -638 4 38.1024 37.7997 2.00291 -4.61511 13.1634 -1.5169 -639 1 45.5865 37.1913 1.18701 0.34656 3.48246 -50.9957 -640 2 46.5715 37.7193 0.263736 40.0587 13.4866 27.3297 -641 2 47.1476 36.6709 41.2495 -9.99518 -39.8037 -22.9547 -642 3 47.6611 35.6473 41.7682 -3.12622 19.3551 -24.5438 -643 4 45.9505 37.0475 2.10099 0.0710674 -6.02767 36.3056 -644 4 46.0766 38.4733 41.5789 -9.05589 19.6465 -18.4972 -645 2 47.8462 38.4064 1.04164 -24.5048 14.2529 -26.5929 -646 2 47.4036 39.6651 1.82888 -3.7708 6.53308 31.1421 -647 2 48.5926 40.4064 2.51341 13.2626 3.99863 -2.76696 -648 3 49.7104 40.5691 1.98441 -24.6046 -10.5895 -1.86534 -649 1 48.3407 40.8898 3.74779 29.4138 -3.81739 16.8938 -650 4 48.597 38.7482 0.246377 -8.81496 -5.86425 14.2737 -651 4 48.3893 37.7509 1.72975 1.66752 -15.4435 3.74234 -652 4 46.6019 39.4971 2.66308 23.3117 -7.11271 -27.0857 -653 4 46.9261 40.3559 1.12913 -3.21242 13.4997 -7.95635 -654 4 47.3907 40.9351 4.12169 -5.60594 2.69026 7.41827 -655 4 49.1659 41.1473 4.37984 -25.8317 -2.18268 -20.985 -656 1 47.0143 36.8241 39.8589 2.94896 -6.17569 33.9376 -657 2 47.6738 36.0506 38.8108 16.6825 -23.5637 34.6067 -658 2 48.454 37.0258 37.9695 9.24498 -19.2444 17.2828 -659 3 47.9734 37.5867 37.0249 -16.9661 22.5794 -32.933 -660 4 46.3407 37.4883 39.4677 -2.13376 9.43233 0.449621 -661 4 48.4374 35.3321 39.3605 -24.6855 17.1776 -23.0678 -662 2 46.6968 35.2528 37.909 -27.9143 -33.2437 25.7199 -663 2 46.039 33.9895 38.7043 9.93401 10.5983 7.56799 -664 2 46.87 32.6784 38.9289 23.0786 -0.450758 -24.5995 -665 1 47.7656 32.5928 40.0651 -0.0346617 67.7235 50.2506 -666 2 48.5337 31.5574 40.3699 -14.5633 -26.8579 -35.9878 -667 1 48.7282 30.552 39.4879 -2.05986 8.25564 18.106 -668 1 48.8872 31.3858 41.6213 -4.84512 27.348 -3.11289 -669 4 47.2327 34.8627 37.0058 -5.81127 5.13112 -1.60937 -670 4 45.8267 35.9464 37.6192 18.3744 -10.9215 -5.83414 -671 4 45.065 33.6697 38.178 15.3305 12.1509 10.6411 -672 4 45.8045 34.3704 39.7428 -14.1926 -3.74807 -10.9265 -673 4 47.5159 32.4832 38.0006 -21.4463 1.51143 8.96621 -674 4 46.1858 31.8178 39.0967 -9.12823 -0.449275 -15.1225 -675 4 47.7485 33.3794 40.8208 -8.02877 -26.8637 -33.9869 -676 4 48.3609 30.5297 38.5261 -2.43008 2.66571 1.08755 -677 4 49.1746 29.6933 39.8011 5.57148 -11.3344 1.43527 -678 4 48.5595 32.0107 0.447997 -4.49593 6.14729 8.57279 -679 4 49.3675 30.5632 41.8859 20.5825 -37.41 17.1512 -680 1 49.6971 37.2567 38.3612 38.8031 36.8466 -19.9315 -681 2 50.6251 38.1764 37.6375 5.59701 -6.58181 11.8605 -682 2 51.1059 37.476 36.33 -5.39593 -3.52342 3.95062 -683 3 51.4567 36.2851 36.3473 -6.1727 9.88097 2.62067 -684 4 50.1666 36.6257 38.9842 10.5469 -17.0261 18.2142 -685 4 50.0436 39.1015 37.4003 1.48542 -2.85918 -9.88003 -686 2 51.8783 38.6033 38.5414 -14.1699 17.2606 4.5582 -687 2 51.4771 39.4948 39.8067 23.634 -8.13025 9.13717 -688 2 52.8025 39.6936 40.6861 -45.72 0.0787629 30.9804 -689 2 51.0312 40.8873 39.3543 -1.21924 6.71403 17.5275 -690 4 52.6247 39.2003 37.9187 -12.0326 -10.2321 5.24388 -691 4 52.4336 37.7304 38.9418 -1.83231 -8.6555 -7.07863 -692 4 50.6844 38.9864 40.4458 6.67436 6.37453 -9.78056 -693 4 52.9275 38.7652 41.2899 1.57503 4.15297 5.5095 -694 4 52.875 40.6185 41.4124 -9.95772 -27.9304 -22.9777 -695 4 53.6477 39.6981 40.0479 39.2622 9.27083 -23.1198 -696 4 51.882 41.4315 38.8764 -8.78739 -1.58992 -12.4168 -697 4 50.8284 41.5065 40.2813 -10.0843 -5.65437 -12.2377 -698 4 50.1041 40.7893 38.7156 9.84678 12.7352 4.22225 -699 1 51.1335 38.2092 35.1872 23.4477 43.7196 -18.1994 -700 2 51.5372 37.7272 33.8205 5.66277 23.826 53.2621 -701 2 52.816 38.5373 33.39 -13.9696 27.2523 3.91394 -702 3 52.9014 39.7954 33.5824 -9.48934 -35.8428 -1.88315 -703 4 51.0917 39.2914 35.1751 -6.07189 -44.7564 8.7296 -704 4 51.807 36.6734 33.9114 3.67702 -17.8942 -3.77347 -705 2 50.2728 37.942 32.9627 24.5619 2.20768 -27.072 -706 2 49.0946 37.0552 33.3907 -40.4332 32.861 4.12747 -707 2 50.6582 37.6771 31.4819 -4.87136 -12.6088 -15.1928 -708 2 49.1924 35.592 33.2496 18.605 -47.1891 -10.6734 -709 4 50.0222 39.0181 33.0462 -10.0421 3.96713 0.824793 -710 4 48.1822 37.369 32.7965 11.3859 0.507389 5.43773 -711 4 48.766 37.227 34.4352 6.35082 10.8857 5.72377 -712 4 49.7261 37.457 30.8365 21.3715 9.42576 10.5226 -713 4 51.3528 36.7896 31.3856 -11.4398 6.26312 1.5823 -714 4 51.2274 38.5516 31.0485 -10.0605 -6.0953 1.35419 -715 4 50.1827 35.2313 33.6939 -19.2762 -1.86106 -7.31237 -716 4 49.1345 35.3223 32.1629 6.46074 -3.78635 4.92713 -717 4 48.3248 35.0641 33.7333 8.66481 1.90115 0.669024 -718 1 53.7674 37.8522 32.7049 -0.401058 29.0536 2.76503 -719 2 54.8534 38.494 31.9889 21.3589 25.2573 -50.7784 -720 2 0.070256 37.9331 30.5159 -12.6617 -10.513 26.1463 -721 3 0.610536 36.8336 30.3273 -13.153 9.14635 -3.0322 -722 4 53.7049 36.8532 32.6778 5.78014 -33.2974 -6.55066 -723 4 54.4976 39.583 31.7137 12.734 -24.0185 30.659 -724 2 1.32523 38.4582 32.6174 -11.2306 -14.0383 43.8112 -725 2 2.25298 39.4244 31.93 21.239 -3.52493 -6.53852 -726 2 1.82142 40.7594 31.946 9.01925 8.15494 1.3639 -727 2 3.55305 39.1373 31.3858 -52.1121 -37.4601 32.7366 -728 2 2.62719 41.7738 31.436 16.1375 42.966 -9.20235 -729 2 4.2717 40.1621 30.8907 55.019 31.5071 -38.7093 -730 2 3.8753 41.5182 30.8618 10.3374 -30.1635 6.5347 -731 4 1.72137 37.3957 32.6071 -2.968 13.2806 -7.3675 -732 4 1.36361 38.7573 33.7485 -10.0277 -6.08615 -32.1159 -733 4 0.900203 41.04 32.4671 -4.90014 4.47018 0.827909 -734 4 4.05865 38.1292 31.3848 -19.507 10.3261 2.47632 -735 4 2.40669 0.963664 31.507 -12.4107 -17.8541 2.52862 -736 4 5.22734 39.8163 30.4261 -2.17835 18.3508 4.41679 -737 4 4.61313 0.382875 30.4956 -18.9116 -9.53382 4.9162 -738 1 54.5208 38.7001 29.536 -17.794 9.59417 2.44526 -739 2 54.4433 38.3677 28.0932 0.413701 6.77287 11.8816 -740 2 53.8236 36.9714 27.8054 -10.5704 38.9519 24.3324 -741 3 54.2836 36.1684 27.0139 12.3723 -16.7122 -9.38408 -742 4 54.0063 39.582 29.8758 15.9225 -27.1932 -25.0825 -743 4 53.6617 39.0994 27.7122 21.1252 -9.31914 -10.5745 -744 2 0.84771 38.4562 27.3872 5.21129 26.4327 0.415045 -745 4 1.55752 39.2926 27.6564 -22.375 -0.429945 3.27523 -746 4 0.737328 38.5366 26.268 -0.662808 -7.52676 8.67249 -747 4 1.44048 37.5755 27.6711 3.3074 -14.1434 -6.0421 -748 1 52.6712 36.7812 28.4639 -34.4859 10.4254 42.9936 -749 2 51.8461 35.5981 28.5315 7.11639 -32.3641 19.2856 -750 2 52.1287 34.6607 29.761 72.1729 37.4894 -16.6197 -751 3 51.2969 33.8912 30.1393 -37.38 -39.1809 16.7772 -752 4 52.2301 37.5459 29.0797 18.7619 -22.9106 -24.882 -753 4 50.752 35.8045 28.6381 6.6344 10.4547 -3.03351 -754 4 51.9318 34.9661 27.6028 3.27123 7.03186 8.45077 -755 1 53.4041 34.6064 30.3039 -37.1524 -18.2668 23.7743 -756 2 53.8481 33.579 31.3343 19.9058 12.4048 -28.9308 -757 2 53.2753 33.7631 32.7245 -4.20442 17.2631 -10.7202 -758 3 53.3264 34.8931 33.2388 -7.00143 -11.8952 2.65621 -759 4 53.9984 35.4233 30.2821 14.046 11.4873 -9.55867 -760 4 53.5575 32.5679 30.9796 -2.97426 -3.20006 -4.3618 -761 2 0.441949 33.6673 31.397 15.483 24.485 -22.5221 -762 2 1.1159 33.1056 30.111 -2.52249 -22.0361 -11.2405 -763 2 2.65939 33.3504 30.0471 -29.7948 -11.8394 -36.8606 -764 2 3.5253 32.433 30.8659 3.71436 3.74322 35.9681 -765 1 4.92891 32.7835 30.8601 -3.73949 -14.6782 3.94495 -766 4 0.930008 33.1164 32.2052 -10.1795 -8.12889 21.2637 -767 4 0.820281 34.7554 31.5264 -17.1946 -20.5931 1.67355 -768 4 0.726808 33.5631 29.1693 -8.69229 5.5421 6.41341 -769 4 0.816642 32.0044 30.0112 14.0154 14.8269 0.94841 -770 4 2.76655 34.4177 30.2798 16.9839 11.3836 1.64388 -771 4 2.99027 33.2006 28.9712 -4.31169 8.16855 10.4317 -772 4 3.48024 31.3628 30.6286 -9.21502 -9.13385 -9.88849 -773 4 3.14214 32.5157 31.9169 10.307 -3.37241 -3.01155 -774 4 5.38024 32.7641 29.968 4.13535 -6.65161 -12.8027 -775 4 5.44585 32.16 31.4735 7.57437 4.94374 1.68638 -776 4 5.11721 33.7072 31.1652 -0.520286 24.3887 13.7994 -777 1 52.7286 32.6609 33.3217 21.3895 7.82715 -40.48 -778 2 52.3746 32.6765 34.6845 -3.94215 -5.7204 42.1903 -779 2 53.6544 32.9612 35.4718 -32.0777 16.7216 -3.31611 -780 3 54.7101 32.4293 35.2196 26.5529 -12.799 -1.69002 -781 4 52.7346 31.7402 32.8358 -3.66087 10.5856 2.03104 -782 4 51.6553 33.4893 34.886 -4.93781 11.2662 -7.45083 -783 2 51.7389 31.3462 35.1425 36.1525 -8.24878 -2.45066 -784 2 50.4549 31.4357 35.902 -2.56298 9.46411 57.003 -785 2 50.5914 31.9702 37.3969 -4.77582 -10.2539 -35.2763 -786 3 49.9129 32.941 37.7385 4.53321 10.1718 7.36032 -787 1 51.4448 31.3274 38.2318 1.89331 10.2207 20.9211 -788 4 52.4532 30.7011 35.7138 0.934865 4.72627 -2.3237 -789 4 51.5619 30.7887 34.2312 -11.1921 -21.1455 -14.7508 -790 4 50.0197 30.4197 36.0127 -8.03636 -0.273264 -6.56567 -791 4 49.7685 32.1089 35.3545 -11.9583 -2.57651 0.31815 -792 4 51.7323 30.3416 38.1022 2.22495 5.18328 -8.30147 -793 4 51.645 31.7871 39.1631 -4.2657 -12.8631 -21.1898 -794 1 53.54 33.8952 36.4131 -39.2018 -0.531466 -0.79929 -795 2 54.5682 34.2648 37.3102 -29.3437 58.7358 21.9421 -796 2 54.3255 33.5954 38.6431 29.6978 -77.406 0.637438 -797 3 53.3742 33.7807 39.3881 -15.8118 22.9548 5.85491 -798 4 52.6165 34.3686 36.5483 14.9252 -1.63515 2.31459 -799 4 0.525104 33.9954 36.8979 32.3496 -27.0675 -4.05845 -800 2 54.6285 35.827 37.4074 -17.7645 -17.3983 39.0191 -801 2 0.013954 36.4546 36.058 15.6745 -1.04323 18.583 -802 2 0.049019 37.9526 36.293 -63.1087 6.90888 -39.4544 -803 2 1.42802 35.9308 35.6826 4.08802 -6.56861 34.108 -804 4 0.435555 35.9801 38.2063 -13.4425 16.5914 -13.2273 -805 4 53.6198 36.2963 37.798 28.292 -21.2068 -7.80607 -806 4 54.2061 36.2134 35.3084 7.36084 -1.04605 -3.46995 -807 4 54.0713 38.2397 36.8522 27.1057 4.55429 -9.55418 -808 4 54.939 38.4282 35.2643 6.0019 1.58695 18.2366 -809 4 0.927863 38.3313 36.762 28.685 14.2218 21.5028 -810 4 1.30489 34.8989 35.3991 1.43296 -22.664 -21.4406 -811 4 2.25694 35.8344 36.4845 -24.5016 17.8738 -12.6534 -812 4 1.83634 36.4362 34.8335 13.635 15.7788 -26.8996 -813 1 0.008587 32.3758 38.733 13.7846 27.3237 -75.0314 -814 2 54.826 31.3 39.6331 17.4428 -14.6066 45.4768 -815 2 0.455793 31.7866 40.9725 -5.37526 1.66294 14.9859 -816 3 1.60943 32.1773 41.0547 11.2247 3.92934 -7.13086 -817 4 0.661532 32.0877 37.9163 -19.8505 19.9989 33.4434 -818 4 53.7452 31.1425 39.875 0.374502 -5.35979 -15.722 -819 2 0.574437 30.0043 39.0439 11.2157 23.6116 11.9724 -820 2 0.334302 28.7136 39.8578 -22.6665 -11.1233 -21.4622 -821 2 0.695999 28.7 41.3625 12.0844 -36.9796 9.0265 -822 3 54.7253 28.727 0.298109 10.889 15.3071 -4.11946 -823 3 1.91063 28.4506 41.7261 -30.7481 15.8042 -10.4483 -824 4 1.71086 30.1341 39.082 -19.7243 9.32222 0.312381 -825 4 0.358791 29.9926 37.9166 -2.62684 -19.8589 21.79 -826 4 0.882365 27.912 39.2891 -0.232785 0.308618 14.1734 -827 4 54.2301 28.3798 39.7718 17.2545 10.1943 -0.206185 -828 1 54.6325 31.7916 0.156881 38.5875 2.07504 -29.8841 -829 2 54.8631 32.3302 1.45975 7.41407 33.4343 26.7616 -830 2 1.21087 32.0241 2.20189 -33.1211 2.89979 -4.9396 -831 3 1.57835 32.811 3.08735 12.0797 -3.2377 -11.0832 -832 4 53.6756 31.6317 41.8616 -38.5912 -7.03962 0.740029 -833 4 54.9627 33.4927 1.3754 -11.7864 -35.033 -4.32612 -834 2 53.6666 32.0355 2.42828 -17.6969 8.95863 -1.18459 -835 2 52.1933 32.3158 2.0402 15.1012 41.0915 -15.9482 -836 3 51.3911 33.0513 2.74715 36.5037 -34.5123 -13.5772 -837 3 51.9207 32.0348 0.835441 -22.1157 -3.97518 6.29873 -838 4 53.9089 32.5595 3.33158 -2.01457 20.6007 30.7692 -839 4 53.6609 31.0051 2.75768 6.68313 -26.6133 3.27231 -840 1 1.77413 30.8239 1.99288 23.346 -11.0551 12.4557 -841 2 2.99412 30.3649 2.70859 20.7873 20.7026 2.58588 -842 2 4.37767 30.5585 1.9432 -4.58172 12.4342 76.2013 -843 3 5.43315 30.6356 2.6242 -17.4542 -1.84538 -14.1099 -844 4 1.23141 30.1158 1.49013 8.16278 -4.42375 -5.05013 -845 4 3.08709 30.9756 3.71749 -2.54673 -19.312 -31.0286 -846 4 2.99418 29.2776 2.99437 -11.6108 14.2547 -3.21828 -847 1 4.33484 30.73 0.643592 -44.4777 10.1896 -41.2897 -848 2 5.29878 31.2923 41.6537 25.3276 0.744315 3.96016 -849 2 5.54544 32.7486 0.121481 37.2819 -30.872 -27.7426 -850 3 4.68176 33.387 0.67546 -18.5336 28.2868 17.8008 -851 4 3.3891 30.7154 0.224796 5.58966 -1.49205 -0.51948 -852 4 6.30256 30.8588 41.8823 -3.47112 -15.4387 -8.82901 -853 2 4.8423 31.1802 40.1578 47.5835 -21.6785 -9.15502 -854 2 4.71332 29.7742 39.4637 -7.18766 34.2596 -8.85866 -855 2 5.63064 28.6968 40.0034 1.34917 -52.5839 -25.1875 -856 1 5.28494 28.1736 41.3081 -3.70672 3.58414 23.7744 -857 2 6.07557 28.0057 0.492928 -10.4577 4.69864 -29.3733 -858 1 7.37832 28.2278 0.392183 22.9004 -4.79637 26.256 -859 1 5.53705 27.6868 1.66636 -6.4094 -24.443 39.9026 -860 4 5.53303 31.787 39.5095 -0.196101 -2.7377 7.98036 -861 4 3.92152 31.7024 40.0755 -40.4143 20.5365 -6.7059 -862 4 4.89215 29.8961 38.3273 -2.53464 -0.592337 23.8175 -863 4 3.64677 29.4833 39.5295 -2.27017 -8.63927 2.61329 -864 4 6.69627 28.939 39.9328 9.42975 10.3347 -2.35439 -865 4 5.48992 27.7969 39.2806 7.04825 21.6687 20.0754 -866 4 4.27254 28.0467 41.4152 -4.83075 -3.28587 3.65899 -867 4 7.98538 28.2099 41.4852 -8.02405 3.18538 -21.0185 -868 4 7.94047 28.2423 1.24565 0.364194 -0.98827 11.7246 -869 4 4.53186 27.4078 1.78766 14.7644 10.3007 -8.4097 -870 4 6.1013 27.52 2.55737 -8.44391 7.70178 -27.0297 -871 1 6.79596 33.2006 41.6804 -27.9344 8.59735 4.57792 -872 2 7.15148 34.5952 41.8655 -38.9276 -12.1291 -1.68573 -873 2 6.77215 35.2911 40.5652 14.0197 56.9428 51.8707 -874 3 6.49158 34.715 39.5569 -13.5951 -21.5425 -43.0675 -875 4 7.31858 32.7386 40.9072 -2.655 4.76346 14.1821 -876 4 6.52583 35.0505 0.829338 19.3934 -10.3795 -24.0216 -877 2 8.63545 34.7883 0.159249 -4.7809 22.3707 74.7553 -878 3 9.31911 34.1951 41.0459 32.4158 -10.9375 -20.7672 -879 2 9.12239 34.1481 1.54228 -45.3508 12.3646 -39.5443 -880 4 8.86138 35.9031 0.177513 1.59938 -13.4643 1.18346 -881 4 10.1943 34.4871 41.2598 15.0836 -7.29109 -20.5697 -882 4 10.1218 34.4779 1.7295 32.9793 8.82002 13.7556 -883 4 9.1354 33.0404 1.45915 -3.89828 -1.77159 7.54964 -884 4 8.44695 34.5279 2.36236 9.39315 -9.78399 0.0431608 -885 1 6.96309 36.6454 40.6555 -22.2962 -38.3404 -33.8498 -886 2 6.94214 37.5275 39.5132 -15.3576 22.9899 27.1878 -887 2 8.03225 37.1821 38.5547 25.8315 2.87875 -39.3086 -888 3 7.87409 37.2091 37.3037 -11.7489 -2.94068 30.2829 -889 4 7.09017 37.0079 41.5812 4.58243 22.402 24.7274 -890 4 6.01646 37.4072 38.9238 -6.0018 -8.28766 -1.15408 -891 2 7.01182 39.0163 40.0252 -15.3603 -23.3284 55.3652 -892 2 5.61926 39.5384 40.7634 13.0639 11.727 -14.3013 -893 2 5.74741 41.0778 41.0735 34.612 -8.65688 -61.1535 -894 2 4.30485 39.278 39.9775 33.2171 6.29002 -24.4772 -895 4 7.23253 39.6079 39.1676 9.01238 29.648 -28.6912 -896 4 7.91826 39.1206 40.7867 -28.368 0.120823 -25.2036 -897 4 5.4532 38.9933 41.7239 13.5286 -1.18368 4.70417 -898 4 4.88701 41.4539 41.5866 -22.2749 9.39049 21.0562 -899 4 5.89633 41.7578 40.1185 -8.19165 -26.548 25.276 -900 4 6.67066 41.2365 41.6556 -0.494064 4.57358 11.7906 -901 4 4.18164 39.8273 38.9933 8.48456 -7.17755 11.4037 -902 4 3.44244 39.5261 40.5797 -17.807 1.17877 7.97341 -903 4 4.2824 38.1939 39.7929 -10.4691 -3.8299 -8.01616 -904 1 9.23783 36.8543 39.0653 -4.40645 21.0053 19.4908 -905 2 10.3275 36.5838 38.1582 31.0816 -25.3995 62.8998 -906 2 10.2997 35.2224 37.4613 6.04581 38.1949 -0.210763 -907 3 11.0208 35.1071 36.4655 -6.3656 -14.3958 -11.0193 -908 4 9.51333 37.1441 40.0706 -14.9717 -14.5173 -38.8343 -909 4 10.386 37.3498 37.3821 -1.67567 12.3369 -13.0834 -910 2 11.6168 36.6846 39.0604 -5.3878 -32.5356 -23.0633 -911 3 11.6818 35.7254 40.0985 -18.2206 13.507 16.8431 -912 4 11.7318 37.6647 39.5052 6.99822 20.9023 2.76215 -913 4 12.4798 36.426 38.4299 12.1644 16.7594 -11.1747 -914 4 12.2479 35.0511 39.7675 10.0745 -20.8981 -3.76732 -915 1 9.3909 34.3264 37.8733 -42.427 -15.3638 26.6935 -916 2 8.99216 33.1557 37.0842 54.1918 17.4661 1.85655 -917 2 8.44195 33.5842 35.7305 -20.833 60.571 55.2199 -918 3 8.45395 32.8337 34.8033 7.91235 -41.3122 -40.5547 -919 4 8.901 34.4208 38.8182 18.72 -3.57692 -25.7233 -920 4 10.0039 32.69 36.8915 -15.1884 -12.4868 -9.34361 -921 2 8.05349 32.1507 37.7268 -1.844 -26.1592 7.76215 -922 2 8.63612 31.2276 38.7905 8.98886 15.2457 3.52798 -923 3 8.28567 31.4376 39.9878 9.18033 -14.5703 -9.08999 -924 3 9.46172 30.3301 38.4185 -14.4281 10.7169 -2.66077 -925 4 7.57008 31.4717 36.9797 -4.32683 11.3708 2.99534 -926 4 7.24557 32.7088 38.1955 -18.7592 7.98312 4.87833 -927 1 7.76821 34.7903 35.7104 -0.921577 -49.5867 -7.77983 -928 2 7.00589 35.2713 34.5947 28.4194 33.7396 -49.4054 -929 2 7.85162 36.3274 33.7967 14.0615 10.3677 50.876 -930 3 7.59561 36.677 32.642 -11.5138 -12.0529 -0.0837023 -931 4 7.64044 35.3156 36.5601 -2.79577 12.0246 16.4277 -932 4 6.95142 34.464 33.8059 -8.74679 1.13416 10.6726 -933 2 5.60472 35.8897 34.9384 -10.82 -34.5279 -29.2679 -934 2 4.80808 34.6511 35.4252 21.4048 19.1212 -24.4535 -935 2 4.58939 34.449 36.7896 -8.79739 7.49237 6.99756 -936 2 4.44707 33.6361 34.4808 -22.1156 13.6667 13.0483 -937 2 3.78406 33.375 37.155 10.056 16.8174 60.0349 -938 2 3.57928 32.5992 34.8543 35.6828 20.067 14.4288 -939 2 3.32606 32.5122 36.2195 -36.4887 -32.5961 -12.2866 -940 3 2.43989 31.6229 36.7148 -5.7594 -17.052 -20.0699 -941 4 5.14192 36.3424 33.9886 5.39246 -18.3577 14.2305 -942 4 5.60606 36.7583 35.5989 7.01287 1.52307 19.367 -943 4 4.94491 35.1783 37.5598 -4.47364 -7.92921 -7.91861 -944 4 4.66046 33.7427 33.4202 4.87397 4.4658 -8.40916 -945 4 3.45738 33.1597 38.2449 15.2806 17.1295 -26.8514 -946 4 3.26795 31.828 34.148 -6.61111 -3.61155 -4.72788 -947 4 2.1868 31.1622 35.9134 -6.91994 -9.03483 11.406 -948 1 8.90205 36.8981 34.5027 -17.2687 17.5401 -60.9896 -949 2 9.70361 38.0134 33.9387 24.2231 -52.0812 37.3823 -950 2 8.8546 39.1711 33.5701 14.7092 18.0593 -4.53516 -951 3 9.06515 39.7643 32.526 6.45085 3.58457 -7.26619 -952 4 9.11675 36.6435 35.4518 3.62665 -3.0608 21.1339 -953 4 10.3861 38.3235 34.818 -10.2978 3.44266 -21.7419 -954 2 10.5787 37.5562 32.7307 -21.6135 -30.8037 4.74181 -955 2 11.6892 38.5091 32.4223 15.379 -13.1594 38.9153 -956 3 11.683 39.1804 31.4042 4.19267 20.0472 -18.4805 -957 1 12.6852 38.53 33.3751 41.3863 26.0224 -13.8263 -958 4 9.85905 37.4261 31.8504 20.0453 2.40541 7.8736 -959 4 11.053 36.5467 32.9319 -7.17885 8.97611 -4.2567 -960 4 12.817 37.8369 34.166 -15.4043 12.1891 -16.4176 -961 4 13.5001 39.2408 33.2564 -39.0039 -25.8302 4.81098 -962 1 7.96197 39.5631 34.4599 -33.9246 23.5433 37.1278 -963 2 7.21007 40.8276 34.5568 -18.3646 -15.2096 -14.7898 -964 2 8.22007 41.896 34.9201 0.758716 14.3361 -6.26955 -965 3 8.97663 41.7874 35.871 13.0919 -8.40756 13.8683 -966 4 7.83943 39.0508 35.3409 8.95409 -9.59767 0.690263 -967 4 6.70734 41.0591 33.5261 17.9743 -2.28149 22.8597 -968 2 6.0301 40.6247 35.6674 21.3841 11.5647 -11.8815 -969 2 4.89974 39.9794 34.8247 17.8968 2.41192 -27.2216 -970 2 5.64567 41.9074 36.4174 -5.31946 16.9228 -22.0167 -971 2 3.85064 39.271 35.6143 -7.9417 -14.8054 48.1955 -972 4 6.41951 40.0018 36.4929 2.02391 -20.04 -2.41117 -973 4 5.36435 39.2019 34.126 -8.73918 7.93575 11.5905 -974 4 4.48342 40.7424 34.1094 -6.00744 -5.42447 8.5897 -975 4 5.00487 41.8434 37.3074 -11.5574 -14.3762 1.01334 -976 4 5.12929 0.689353 35.6946 7.17582 1.37977 8.89479 -977 4 6.56067 0.460605 36.8355 2.18467 8.54142 -3.2903 -978 4 3.23423 39.9796 36.2601 8.91814 -10.815 -11.4927 -979 4 4.38489 38.5352 36.333 -17.3309 14.265 -14.1697 -980 4 3.16246 38.6765 34.9814 -1.3822 0.0882741 -1.23744 -981 1 8.27901 1.09677 34.1745 -17.8694 -35.8502 15.8719 -982 2 9.1495 2.17731 34.4611 25.5007 24.1899 -15.5427 -983 2 8.44305 3.45517 34.8181 7.33507 13.3767 -14.0082 -984 3 7.22584 3.58853 34.5952 14.73 6.44535 13.4701 -985 4 7.64387 1.07834 33.3925 -5.10967 17.8437 -25.4682 -986 4 9.72616 1.98981 35.3795 6.67437 -11.367 8.50474 -987 2 10.1416 2.3939 33.2727 7.80857 1.28792 -5.65283 -988 2 11.1754 1.27875 33.0535 -29.5709 -1.62172 8.74553 -989 2 12.298 1.25902 34.0434 45.8123 -20.4226 -15.8942 -990 3 13.4264 1.60062 33.6211 -9.09849 2.20405 14.6225 -991 1 12.1286 0.499484 35.1615 13.5856 38.0862 1.93866 -992 4 10.7117 3.33658 33.4062 0.0269402 1.80508 0.780117 -993 4 9.62868 2.54332 32.3022 -11.3844 1.67988 3.84081 -994 4 11.6026 1.39089 32.0291 1.1132 -6.32648 1.88738 -995 4 10.6463 0.304077 33.1517 4.80745 -4.48978 -13.057 -996 4 11.1623 0.324257 35.4356 -7.1112 -9.24345 12.7946 -997 4 12.86 0.645961 35.8984 -11.3978 -13.87 -11.7385 -998 1 9.29061 4.442 35.2624 -22.3208 40.9019 24.8252 -999 2 8.81116 5.82611 35.6978 -18.3987 -9.60009 -41.1421 -1000 2 7.90959 6.36535 34.5148 35.1086 -14.4229 -13.6713 -1001 3 8.27789 6.14754 33.3333 -13.6173 9.04219 21.6414 -1002 4 10.326 4.35425 35.3433 -15.5473 -10.8229 -5.10085 -1003 4 8.07437 5.70026 36.5174 9.02025 -1.47766 10.124 -1004 2 9.99583 6.76313 36.1565 -25.1565 20.6308 -28.9867 -1005 2 11.135 6.93617 35.1361 2.62363 -10.5046 6.46017 -1006 2 12.4502 7.42969 35.8581 -25.4448 -27.2564 -27.4451 -1007 2 12.3858 8.85842 36.3442 -55.084 26.5775 24.6628 -1008 1 13.634 9.41318 36.7712 33.8844 -44.8334 11.878 -1009 4 10.2929 6.30703 37.0832 24.0012 -1.96783 25.2264 -1010 4 9.73373 7.84957 36.4159 -14.1304 -26.7275 0.147522 -1011 4 10.8081 7.68154 34.3572 5.16283 -4.02502 4.78839 -1012 4 11.298 5.9636 34.5725 5.23915 16.0099 8.41141 -1013 4 13.159 7.4137 35.035 25.5516 -2.14082 -10.0364 -1014 4 12.8083 6.68649 36.6117 -1.06896 6.08822 -0.205097 -1015 4 11.642 8.94716 37.2538 22.1051 -1.45756 -27.4817 -1016 4 11.9592 9.50431 35.5025 9.97141 -3.64215 15.7788 -1017 4 13.6538 10.3723 37.0555 -8.09423 13.3796 3.79584 -1018 4 14.2885 9.3339 36.0056 2.60625 13.8446 -5.44478 -1019 4 14.0928 8.83644 37.5176 -15.06 24.3666 -13.6607 -1020 1 6.73429 6.959 34.8261 9.36917 -0.537504 -3.37326 -1021 2 5.68914 7.48312 33.9811 -11.6093 0.198368 -29.7566 -1022 2 4.72257 6.43001 33.3633 23.9678 57.8121 29.6097 -1023 3 3.69345 6.80336 32.8731 -41.5354 18.269 -25.9458 -1024 4 6.5403 7.08067 35.8075 -8.4584 6.57489 23.7637 -1025 4 4.95828 8.08289 34.6274 18.5559 -1.63885 -10.0577 -1026 2 6.30301 8.33887 32.7628 1.61604 -0.894199 46.3222 -1027 2 6.96232 9.68302 33.2113 17.5203 -12.0258 -13.4607 -1028 2 6.11334 10.8061 33.8152 -7.60378 12.6352 19.0416 -1029 3 5.31496 11.4419 33.0422 10.0378 -5.26853 5.86857 -1030 3 6.28181 11.1536 35.05 3.36103 -18.7342 -31.8229 -1031 4 5.5011 8.60814 32.0808 -13.4162 -1.3456 -15.0867 -1032 4 7.01778 7.64283 32.2215 -8.51236 18.4517 -1.11608 -1033 4 7.483 10.1113 32.3225 -5.01151 2.49106 -4.14977 -1034 4 7.84021 9.44334 33.8428 -3.17944 -2.15711 8.7111 -1035 1 4.98957 5.17145 33.408 31.7294 -73.5208 5.3031 -1036 2 4.03057 4.12888 32.9492 20.6717 -14.7005 -20.2168 -1037 2 2.6598 4.36206 33.592 -3.0444 -3.65398 -36.823 -1038 3 2.63368 4.6245 34.7729 -17.9957 9.5377 28.5993 -1039 4 5.93287 4.88555 33.7778 -25.4301 -4.21673 -10.3446 -1040 4 3.97065 4.08898 31.7849 -0.621936 10.7688 28.6704 -1041 2 4.54797 2.73693 33.4323 -9.78314 13.2989 35.3654 -1042 3 5.7396 2.38581 32.8061 3.87836 -1.00687 -28.9834 -1043 4 3.83029 1.94659 33.1597 -9.96533 -6.0451 7.8725 -1044 4 4.7579 2.77573 34.5879 -14.8326 -6.64015 -28.538 -1045 4 6.39905 2.57303 33.4496 16.1931 5.10903 8.49462 -1046 1 1.55493 4.20465 32.7937 9.73391 7.12296 -2.26043 -1047 2 0.143907 4.28394 33.2313 13.768 -18.1657 13.0528 -1048 2 54.6863 2.83094 33.3214 -0.0746788 -18.1404 42.9803 -1049 3 54.7972 2.04898 32.3833 -5.36381 -6.57018 -20.4337 -1050 4 1.75536 3.84626 31.8337 -17.5999 5.97734 12.9737 -1051 4 0.145346 4.72929 34.2869 -5.52407 -1.41906 -16.7638 -1052 2 54.0936 4.99047 32.3072 48.5491 53.4262 27.9832 -1053 3 54.4431 6.39026 32.3568 26.5828 -36.1107 8.98461 -1054 2 52.7233 5.01429 32.8691 -55.1486 3.23885 2.70228 -1055 4 54.1505 4.66496 31.2868 0.0550865 -16.0071 -29.7017 -1056 4 53.7986 6.85268 31.88 -20.6445 25.8891 -20.893 -1057 4 52.6197 5.54793 33.8322 5.93951 -5.3567 9.34144 -1058 4 52.3467 3.98503 32.9647 -9.06602 -5.34833 4.63236 -1059 4 51.9747 5.55452 32.2255 9.49609 -7.51028 -3.22615 -1060 1 54.1802 2.39741 34.5222 -14.8232 32.9081 27.5353 -1061 2 53.4465 1.14651 34.785 33.9277 15.1 -62.0226 -1062 2 52 1.44639 34.4384 -40.9452 -8.29472 -14.3346 -1063 3 51.516 2.52365 34.8247 -1.26544 -9.47139 -8.9244 -1064 4 54.0715 3.07846 35.3501 9.6448 -17.4772 -31.2652 -1065 4 53.9076 0.391021 34.1043 -10.2836 -7.20705 -0.475865 -1066 2 53.6069 0.737389 36.2058 40.6624 3.41232 47.0409 -1067 2 0.15698 0.778637 36.8849 -22.9225 14.5477 7.59965 -1068 2 0.184063 0.045177 38.2545 -1.48959 -18.0819 6.68284 -1069 2 1.19764 0.213126 35.924 -17.0247 17.4527 -16.4279 -1070 4 53.1759 41.6554 36.3315 -4.28574 -19.6707 2.88188 -1071 4 52.9166 1.40322 36.7387 0.80484 4.57892 22.2756 -1072 4 0.570353 1.84035 37.1024 -27.1105 -11.6335 -5.02718 -1073 4 54.3756 0.329349 38.9832 1.77724 8.98271 -8.45905 -1074 4 1.16626 0.241414 38.7954 -11.8595 -7.79047 -8.4361 -1075 4 0.0237 40.841 38.1265 8.8292 11.305 -0.869273 -1076 4 2.1582 0.044818 36.439 11.171 3.86438 -4.7836 -1077 4 1.22244 1.0066 35.1406 25.1303 -1.4606 -0.0516333 -1078 4 0.965216 41.2564 35.3038 -8.75588 -20.9773 6.66787 -1079 1 51.2089 0.49816 33.7614 57.6433 8.13256 28.0245 -1080 2 49.794 0.627079 33.5149 3.58551 37.6409 23.5907 -1081 2 49.1504 41.7362 34.5845 -39.3958 -31.0429 53.6988 -1082 3 49.3072 40.5133 34.7023 12.9245 12.8492 -11.6005 -1083 4 51.5663 41.4343 33.8516 -6.054 3.49016 -14.1934 -1084 4 49.5236 1.72635 33.6347 -1.89472 -11.9516 -1.26615 -1085 2 49.2899 0.093076 32.2111 -20.0469 10.239 -57.1496 -1086 2 49.5504 1.0758 31.0546 44.1484 5.96661 -35.419 -1087 1 48.7105 2.02971 30.4517 -2.34523 -25.3315 39.2373 -1088 2 50.7977 1.22066 30.3277 -75.7848 7.88288 4.96893 -1089 2 49.299 2.59293 29.3763 -23.865 8.39496 11.0232 -1090 1 50.5677 2.14293 29.3127 -12.36 -15.4034 27.3398 -1091 4 48.1533 41.8436 32.187 18.4481 1.21563 9.00361 -1092 4 49.725 40.9798 32.0543 -2.35302 7.24771 -7.56512 -1093 4 47.7373 2.26457 30.8018 19.6426 -7.09987 -8.69392 -1094 4 51.6402 0.582035 30.3922 15.3203 -1.97636 0.19948 -1095 4 48.6832 3.25559 28.7541 24.649 -5.28154 -1.94766 -1096 4 51.2124 2.39582 28.5799 18.4236 6.97779 -14.3308 -1097 1 48.3633 0.438016 35.503 -1.69139 30.1001 11.6909 -1098 2 47.6687 41.7006 36.6492 0.613805 18.6924 -40.9612 -1099 2 46.264 41.3694 36.1307 -7.02361 -30.4834 5.87484 -1100 3 45.3463 0.246853 35.8895 18.8914 5.06283 8.3795 -1101 4 48.1281 1.45816 35.4039 5.5506 -16.4063 -0.101422 -1102 4 48.2062 40.7837 36.9784 6.36967 -2.21031 -8.42979 -1103 2 47.5958 0.687745 37.8565 -25.4558 59.2473 29.5222 -1104 2 46.6931 0.064749 39.0402 -2.78345 4.00632 18.8053 -1105 2 47.0383 40.4557 39.4221 -33.2538 18.6268 -20.4936 -1106 2 46.93 0.927044 40.3419 31.4794 -11.2994 1.29194 -1107 4 47.1354 1.76149 37.5629 9.48386 -42.5729 7.15928 -1108 4 48.6298 0.997945 38.2155 -14.6806 -19.3715 -2.98409 -1109 4 45.5391 0.148422 38.8474 30.3772 -4.98305 -7.99897 -1110 4 47.9695 40.2725 39.9165 32.6255 3.33763 11.188 -1111 4 46.9967 39.7545 38.5575 0.158611 5.44488 0.559019 -1112 4 46.2719 40.0836 40.1333 -2.82757 0.291607 -0.331179 -1113 4 48.0832 1.04093 40.5802 -35.3824 -1.71169 -8.39188 -1114 4 46.4823 0.388091 41.2333 0.118939 13.4124 -7.57083 -1115 4 46.4764 1.95182 40.2253 3.79994 -8.06745 5.67231 -1116 1 46.1155 40.0363 35.9994 32.2071 3.49142 -20.6914 -1117 2 44.9353 39.2817 35.7114 0.014229 -40.6503 61.2515 -1118 2 44.4179 38.8949 37.157 4.06758 -27.6469 18.473 -1119 3 45.1574 38.4668 38.0935 -15.0116 19.769 -34.2637 -1120 4 46.9934 39.487 36.0733 -14.8983 -9.5139 0.794979 -1121 4 44.1193 39.9156 35.4266 -15.9448 22.0113 -37.9939 -1122 2 45.2307 37.9502 34.8403 3.73878 29.7444 42.1248 -1123 2 44.043 37.0324 34.841 -52.9272 -13.7306 14.9234 -1124 2 45.6185 38.368 33.4399 7.42128 1.51593 -38.9882 -1125 4 46.0406 37.394 35.3664 8.69137 1.61483 -3.86581 -1126 4 43.4486 36.945 35.811 20.0159 3.18287 -12.2628 -1127 4 44.3645 35.9957 34.6605 0.118723 -8.68919 -11.9568 -1128 4 43.2413 37.3473 34.1301 7.80666 -3.9283 -7.25571 -1129 4 46.619 38.86 33.4411 -0.357581 -2.40345 0.816384 -1130 4 44.931 39.1517 33.0584 -3.3954 -0.0150932 -1.42103 -1131 4 45.65 37.5606 32.6192 -0.759822 9.78394 24.304 -1132 1 43.0637 38.9039 37.3301 16.2039 -1.11298 52.5829 -1133 2 42.3901 38.4825 38.6382 8.13363 32.9232 -36.228 -1134 2 41.8706 37.0909 38.467 10.8397 -12.8704 71.8875 -1135 3 41.4837 36.7016 37.4073 -23.2793 -18.8499 -56.9312 -1136 4 42.5052 38.9697 36.5072 -31.8536 4.61581 -21.2592 -1137 4 43.1805 38.4127 39.3754 18.2924 -0.774441 22.1039 -1138 2 41.3003 39.5089 39.1545 11.9555 -3.56475 0.849013 -1139 2 41.9844 40.8891 39.6202 11.8289 -38.672 35.4909 -1140 2 41.1032 0.170603 39.4187 0.299182 35.0028 -21.1028 -1141 2 42.4599 40.8175 41.1074 30.4283 -6.43954 -3.58257 -1142 4 40.7378 39.0113 40.0259 3.55617 13.764 -16.8053 -1143 4 40.5882 39.6834 38.2893 4.7664 -2.44084 15.6093 -1144 4 42.9174 41.0251 39.0897 16.4872 7.11459 -27.4623 -1145 4 41.5448 1.21778 39.6878 -5.64292 -30.3916 -9.38981 -1146 4 40.1969 0.063548 40.0003 -21.2204 -0.202137 11.1399 -1147 4 40.8028 0.152067 38.3319 -0.566182 12.1591 9.51378 -1148 4 41.6814 40.5448 41.8308 -8.42244 -8.91154 4.32363 -1149 4 42.887 41.7652 41.4977 -6.37808 7.37928 -6.87517 -1150 4 43.378 40.1338 41.1957 -24.337 0.845851 0.000130478 -1151 1 41.833 36.287 39.5864 -11.7269 -9.12911 -32.1296 -1152 2 41.2021 34.942 39.6247 -13.3362 -7.3841 -33.9439 -1153 2 39.8438 35.1095 40.3167 -2.23182 -18.8086 0.488263 -1154 3 39.8319 35.4679 41.5133 -14.6884 5.15074 -23.9167 -1155 4 42.1857 36.6275 40.4819 6.41783 1.01312 8.70708 -1156 4 41.0734 34.4248 38.4971 0.391294 34.8961 43.783 -1157 2 42.0436 33.9307 40.4129 10.4134 -33.9193 29.8386 -1158 2 41.3224 32.6645 41.0046 18.9395 -8.84266 -15.0635 -1159 2 42.1741 31.41 41.1086 26.4224 -37.0889 -5.20117 -1160 1 43.3231 31.527 0.12404 8.16009 54.2467 4.49909 -1161 2 44.392 30.7336 0.312631 -11.8213 -13.5239 -25.8004 -1162 1 44.683 29.6211 41.5456 -0.875823 -13.5136 -9.93246 -1163 1 45.3567 31.1357 1.10637 -40.5913 52.4111 16.4216 -1164 4 42.6035 34.3028 41.3288 -3.49471 12.9719 -23.3931 -1165 4 42.7742 33.539 39.6653 10.0701 4.50298 5.32726 -1166 4 40.5106 32.3417 40.3808 -25.7726 1.2565 -24.6898 -1167 4 40.8602 32.7415 0.05618 -15.4481 23.3498 31.3369 -1168 4 42.5775 31.2408 40.0556 -4.97325 -9.97334 14.9806 -1169 4 41.5239 30.4863 41.4302 18.1675 25.5375 -11.7586 -1170 4 43.4773 32.5278 0.495625 -12.2609 -36.3484 -6.98406 -1171 4 44.1847 29.2591 40.6938 -0.904676 10.2844 18.7349 -1172 4 45.5197 29.0942 41.8602 -5.70345 -5.08504 -8.10101 -1173 4 45.1981 31.9946 1.67722 9.89922 -9.52065 -4.53153 -1174 4 46.1063 30.5613 1.39407 36.7186 -26.409 10.0907 -1175 1 38.7328 34.6894 39.6013 4.46457 11.7984 -0.102478 -1176 2 37.3765 34.7683 40.1611 -21.3466 -3.56213 -4.53749 -1177 2 37.2086 33.6902 41.246 35.3807 -34.3386 -58.3615 -1178 3 37.7056 32.5617 40.9531 -12.3371 14.3328 36.9617 -1179 4 38.7903 34.2139 38.6548 1.70782 19.6852 25.699 -1180 4 37.2103 35.7436 40.6571 5.74575 10.1154 -0.0963519 -1181 2 36.2415 34.546 39.0669 -3.18027 -0.0437456 15.212 -1182 2 36.1408 35.6492 37.9204 39.4301 -27.8538 10.4422 -1183 2 35.3755 35.0392 36.7616 2.61616 7.91146 -44.6699 -1184 2 35.4893 36.9279 38.4153 -43.6456 26.6605 -35.0263 -1185 4 35.2587 34.5127 39.627 5.22859 0.340849 -7.95454 -1186 4 36.3572 33.4874 38.6664 0.260323 14.7009 0.217726 -1187 4 37.2087 35.8382 37.5664 -16.1128 3.65721 5.42823 -1188 4 35.4477 35.6456 35.7653 9.36321 -17.9472 26.5571 -1189 4 34.3056 35.0154 36.9225 -21.8403 -4.8414 12.2215 -1190 4 35.6878 33.9672 36.6241 -0.675121 9.51327 -11.2908 -1191 4 35.3533 37.7352 37.5449 14.646 -26.9923 30.0517 -1192 4 36.0883 37.365 39.2255 0.238586 8.99863 9.94523 -1193 4 34.398 36.7236 38.7331 27.4296 3.60145 2.66053 -1194 1 36.5178 33.9861 0.43319 -0.886806 18.5628 10.9627 -1195 2 36.4316 33.2481 1.68402 -23.714 -26.6299 -2.13495 -1196 2 35.1244 33.7124 2.42366 15.5385 -30.3313 2.36588 -1197 3 34.7644 34.9026 2.51705 2.20922 -14.5348 -10.7235 -1198 4 35.9714 34.8641 0.38304 3.21168 -9.87759 6.15105 -1199 4 36.3983 32.0948 1.44989 -1.82422 33.6343 5.26777 -1200 2 37.6595 33.5578 2.59019 11.8109 -15.526 -8.95992 -1201 2 37.7925 32.6548 3.8947 -1.46637 37.0951 -40.7395 -1202 2 39.0729 32.9162 4.76145 9.33062 17.9701 -6.69315 -1203 1 39.1272 34.3057 5.34055 -12.0513 -47.2871 -14.6565 -1204 2 40.0361 34.6964 6.22226 19.4309 2.99614 33.8109 -1205 1 41.0505 33.9844 6.76852 5.72064 -28.58 -41.8643 -1206 1 39.7581 35.8909 6.75898 -16.291 -41.0737 -43.8581 -1207 4 37.6558 34.6526 2.69615 5.74115 8.80853 20.4616 -1208 4 38.5677 33.342 1.97837 2.62182 1.38243 0.976295 -1209 4 37.7082 31.6119 3.52088 7.51898 -7.43262 10.1799 -1210 4 36.8684 32.8569 4.46033 -3.22235 -4.22142 15.6354 -1211 4 40.0987 32.7161 4.26669 -27.6432 -2.90908 0.926336 -1212 4 38.962 32.1623 5.56307 10.4764 0.325422 12.3641 -1213 4 38.2956 34.9173 5.26655 4.54825 -8.39051 -8.34855 -1214 4 41.5169 33.1039 6.38476 -28.6266 25.8655 1.14646 -1215 4 41.608 34.3491 7.51377 7.8916 19.9746 23.1278 -1216 4 38.9281 36.336 6.40181 -18.5651 19.0558 1.42199 -1217 4 40.2702 36.4189 7.40653 35.8571 19.9594 40.0309 -1218 1 34.4344 32.6714 2.9841 11.9274 27.4669 5.1488 -1219 2 33.2874 32.9292 3.81699 -8.08564 -7.68863 -5.88537 -1220 2 32.3224 31.7651 3.90854 -17.2979 -17.3182 38.1098 -1221 3 31.6331 31.611 4.98833 24.1293 6.49939 -41.9496 -1222 4 34.8176 31.7057 3.00707 -6.83555 3.8884 -0.368261 -1223 4 33.5991 33.291 4.83995 -4.39941 -8.915 -13.4113 -1224 4 32.6658 33.7351 3.38441 -0.220857 8.92322 -1.65762 -1225 1 32.2676 30.8833 2.86064 7.18924 -6.28537 -11.1453 -1226 2 31.5304 29.6622 2.84554 -44.3988 -8.55194 41.4736 -1227 2 32.0114 28.4719 1.98523 24.1065 42.5964 20.3644 -1228 3 31.2338 27.9142 1.1781 -2.45095 -15.5808 -11.9787 -1229 4 32.835 30.9065 1.99868 7.60542 11.1676 6.22148 -1230 4 31.4977 29.325 3.94534 -1.848 -5.68036 -21.1002 -1231 4 30.428 29.9278 2.63242 23.021 -11.1829 0.219584 -1232 3 33.2484 28.1785 2.03016 -12.1294 -5.65166 -6.61988 -1233 6 29.6841 33.0367 2.60309 -21.6771 -19.3453 -3.47113 -1234 4 28.7948 33.122 2.96731 -0.0142705 6.34055 1.55972 -1235 4 29.6278 32.12 2.27587 17.6678 13.2788 -5.74715 -1236 6 1.91248 24.7582 28.0699 4.20875 0.224039 17.8866 -1237 4 1.01839 24.445 28.2798 3.51323 0.855994 -2.65004 -1238 4 2.43926 24.5752 28.8738 -5.90795 -3.90565 -13.7536 -1239 6 8.97597 35.4266 7.06834 5.04 -9.06312 -1.25332 -1240 4 8.25108 36.0541 6.94232 -0.597114 -1.88223 0.564045 -1241 4 9.78632 35.9205 6.90416 2.6498 8.25727 -2.9232 -1242 6 37.9306 35.2271 23.5275 -29.4197 8.6633 8.88923 -1243 4 37.6331 35.3765 22.6307 -13.538 -1.59668 -6.74716 -1244 4 38.842 35.1051 23.4294 41.2281 -9.97035 -1.96517 -1245 6 11.37 34.6061 20.3231 29.8185 18.8627 -18.7977 -1246 4 10.4583 34.7066 20.5358 -23.2141 -5.0309 12.4901 -1247 4 11.7775 33.9686 20.9051 -0.738527 -14.291 8.66526 -1248 6 3.04799 13.1152 13.5136 35.0099 19.4917 13.0876 -1249 4 2.1896 12.8159 13.7818 -12.1985 -3.35561 6.33527 -1250 4 3.35102 13.7724 14.1976 -9.84998 -14.2313 -17.3692 -1251 6 9.17749 22.3786 24.885 -4.81993 3.49977 17.5169 -1252 4 8.99718 21.9861 24.0258 2.67933 0.293026 -6.97176 -1253 4 8.3097 22.5185 25.3032 2.93356 -2.2731 -6.67367 -1254 6 31.1417 36.1188 7.44168 3.96214 -4.62609 4.57576 -1255 4 30.9859 35.1633 7.26174 3.91063 19.8072 -8.10584 -1256 4 31.8759 36.4086 6.86762 -9.43736 -11.0335 0.220205 -1257 6 20.3122 0.171955 30.1364 24.228 8.43021 7.74329 -1258 4 20.1467 1.09565 29.8896 -9.06662 -5.17995 0.122132 -1259 4 21.2388 0.205679 30.4532 -11.6638 -2.99571 -4.85501 -1260 6 32.6752 3.01477 5.14905 7.73556 0.409651 25.0992 -1261 4 32.0607 2.27652 4.98052 6.16059 10.1356 9.58904 -1262 4 32.7887 3.0902 6.13894 -10.3787 -11.0045 -24.4474 -1263 6 26.2394 8.28697 11.5977 20.1187 4.68976 23.8355 -1264 4 26.2546 7.39802 11.997 -1.81228 7.23555 -2.12718 -1265 4 26.8422 8.82061 12.1901 -18.4274 -19.7459 -23.7973 -1266 6 1.08156 20.2558 0.892389 0.445896 -40.4816 -11.3523 -1267 4 0.921065 19.2784 0.845371 -9.22979 28.4068 22.5673 -1268 4 1.8129 20.2775 0.290341 19.5395 18.0975 -11.5753 -1269 6 29.152 22.9159 1.42964 -10.353 11.3862 1.77115 -1270 4 28.6638 23.7219 1.70393 12.045 -15.0113 -5.27942 -1271 4 29.6471 22.6066 2.20087 0.367353 7.17244 2.17898 -1272 6 34.1439 34.8173 6.47837 -14.6134 34.7664 -13.6599 -1273 4 34.8234 34.3556 6.01831 17.3611 -13.8412 -2.82442 -1274 4 33.8746 34.3136 7.2252 -0.385324 -14.0922 18.4225 -1275 6 25.1602 37.1811 26.5285 37.3138 -10.4299 -24.6025 -1276 4 24.6611 37.8475 26.9305 -29.1138 25.753 30.5337 -1277 4 25.9902 37.6718 26.3423 -2.02618 -10.7722 -5.27175 -1278 6 14.5359 22.233 15.6757 -38.1082 -52.4317 -17.2355 -1279 4 14.0373 21.3219 15.6008 31.4468 51.1923 15.0921 -1280 4 14.2115 22.7284 14.9124 6.42666 2.88962 4.6194 -1281 6 2.85765 5.85542 4.07926 -11.0889 31.9932 11.5474 -1282 4 3.43051 5.71014 4.8302 4.50985 -17.8875 11.7313 -1283 4 2.47546 6.74142 4.27679 -1.8522 -19.462 -7.62003 -1284 6 27.6173 26.7153 22.7048 3.02536 -24.7668 37.2 -1285 4 26.7794 26.2561 22.7471 -5.49099 -10.4557 3.23975 -1286 4 27.5338 27.2427 21.9498 -2.81898 29.5538 -40.3285 -1287 6 17.7815 0.60275 22.3967 -9.44347 22.192 16.8557 -1288 4 17.1106 0.664367 23.1174 8.05472 -4.70436 -13.4643 -1289 4 18.0991 1.53066 22.3547 -2.50437 -12.3009 -7.04453 -1290 6 8.08803 9.43976 10.5674 4.80966 -47.9744 28.0614 -1291 4 8.01535 10.2871 10.1695 -8.25869 32.7817 1.56345 -1292 4 8.12483 9.46261 11.5696 0.628604 12.1613 -30.4224 -1293 6 15.3459 8.71493 30.7579 -11.6347 7.91644 6.32427 -1294 4 15.6589 9.0755 29.9373 15.0271 -3.29406 -15.5675 -1295 4 14.5238 9.21191 30.8811 4.80809 -7.40019 11.405 -1296 6 11.0133 17.2839 37.5617 38.0352 -12.2544 -11.7999 -1297 4 10.7898 18.2056 37.405 -17.5453 -0.0751596 7.29682 -1298 4 10.2607 16.7791 37.8546 -17.0302 3.42722 4.74802 -1299 6 42.1004 25.1498 20.3879 -5.861 18.5914 -24.6259 -1300 4 41.6093 25.7579 19.7998 14.6917 -4.46771 2.10695 -1301 4 41.6207 25.2703 21.1911 -4.19275 -5.86855 25.2901 -1302 6 25.8665 4.70671 33.8486 1.7241 -2.25531 12.4518 -1303 4 25.7694 4.46132 32.9448 -0.891619 -14.6084 -22.569 -1304 4 25.7648 5.65611 33.7952 0.475958 14.7418 11.4125 -1305 6 28.7412 10.81 24.3536 52.8166 -39.1996 0.778281 -1306 4 29.1275 10.6396 25.241 -21.7381 14.0631 -10.6288 -1307 4 29.4032 10.2753 23.8346 -27.1554 16.6107 -4.2243 -1308 6 5.01189 41.8147 11.1021 -10.1881 -24.042 21.7575 -1309 4 5.95007 41.5814 10.9281 -9.39093 5.64723 11.7156 -1310 4 4.65803 41.218 11.8386 16.8172 15.7397 -32.6044 -1311 6 51.752 12.7769 30.1551 43.115 4.76279 10.9474 -1312 4 51.4305 13.1775 29.3474 0.253404 7.28674 -13.194 -1313 4 52.748 12.9494 30.1798 -32.3905 -5.4963 0.108494 -1314 6 7.60816 6.20909 6.53323 -10.2625 -22.9413 3.332 -1315 4 6.75131 6.36879 6.93991 1.04412 16.1391 1.16177 -1316 4 7.47061 5.28848 6.27373 8.51121 0.713964 -9.51027 -1317 6 14.6661 26.987 30.1548 0.873164 4.36141 0.355215 -1318 4 14.582 27.1099 31.1251 1.36022 -4.92112 -14.8153 -1319 4 15.2266 27.7026 29.8055 -8.21389 -0.931444 11.6021 -1320 6 15.3264 3.73283 21.1643 -10.33 -3.58504 -6.01241 -1321 4 14.8638 4.27764 21.8464 -0.83547 -19.2341 -16.6374 -1322 4 14.7237 3.15769 20.6119 12.9204 22.2517 21.9232 -1323 6 18.6273 30.44 6.46759 12.0392 -23.7352 17.6185 -1324 4 19.0475 29.6706 6.98693 -16.3462 35.3997 -15.3304 -1325 4 19.3457 31.0864 6.33287 -5.93154 -6.64461 4.30044 -1326 6 40.7697 1.30953 12.81 -7.42069 2.69181 -0.220133 -1327 4 39.8771 1.67487 12.9664 8.30469 -1.85755 -8.75546 -1328 4 41.0842 1.69163 11.9727 1.23155 -3.30642 0.910493 -1329 6 17.7383 20.7435 41.5913 -9.25323 7.68498 -13.188 -1330 4 16.7989 21.0745 41.5362 27.0903 -5.35562 -1.00027 -1331 4 18.2994 21.1605 40.9095 -9.45455 4.50919 10.4973 -1332 6 20.4558 2.13279 12.3403 -30.0447 18.1891 -47.0851 -1333 4 19.8108 1.39557 12.2573 15.3988 9.29294 19.6505 -1334 4 20.198 2.64755 11.5038 12.9177 -17.2886 33.121 -1335 6 9.85302 37.1833 18.074 6.71136 -14.9304 -23.7857 -1336 4 9.92221 37.5908 18.9423 10.0316 4.42551 4.50256 -1337 4 10.7455 37.1149 17.635 -18.8442 6.56171 18.5414 -1338 6 22.8282 7.40677 18.9114 -6.23678 0.804763 -35.7596 -1339 4 23.277 7.74075 18.0859 -11.7777 -2.90663 21.4919 -1340 4 21.8757 7.287 18.6972 16.9035 1.85128 0.334711 -1341 6 12.8573 6.85868 39.0594 6.78943 -21.4649 -19.4044 -1342 4 12.3495 7.63841 39.2092 -16.9303 20.8315 3.03628 -1343 4 13.4346 6.77393 39.8096 4.28484 1.06254 16.6435 -1344 6 10.1565 2.40612 23.2517 -6.6479 23.561 31.1588 -1345 4 10.4099 1.98923 22.4441 -4.01424 -6.38426 -29.0568 -1346 4 9.49005 3.10319 23.0571 9.63138 -11.2124 -3.87372 -1347 6 12.5542 20.2161 19.5705 -7.34833 3.07917 -34.9419 -1348 4 11.7057 19.8107 19.7825 -3.93433 -3.45282 3.31954 -1349 4 12.4683 20.3478 18.5882 13.2674 0.522362 30.6915 -1350 6 53.8557 6.35775 18.9347 50.5758 7.3162 -16.743 -1351 4 53.0168 6.07594 19.2456 -23.2698 -10.9568 16.0684 -1352 4 54.5479 6.04339 19.5529 -19.4302 5.44353 -5.27334 -1353 6 1.75058 4.00903 13.2441 23.5728 -28.6973 -20.2265 -1354 4 1.21884 4.54583 13.7916 -24.4496 15.7193 15.6535 -1355 4 1.39876 3.10072 13.3493 7.47096 11.1043 -1.96467 -1356 6 2.68902 16.4655 4.58797 17.5454 -16.7281 26.1549 -1357 4 3.46748 16.2798 5.17846 -23.6637 11.3752 -17.7986 -1358 4 3.0109 17.1109 3.97132 2.36318 9.59715 -15.9168 -1359 6 22.6274 7.40182 35.0529 -33.099 -8.93325 -69.8706 -1360 4 21.8922 7.07895 34.3703 46.348 20.1786 48.898 -1361 4 22.5995 6.76718 35.7474 -8.35572 -20.8537 22.0506 -1362 6 30.6396 27.885 19.9 19.0923 35.3411 -25.0547 -1363 4 31.1106 28.5954 19.3754 -18.5592 -24.8751 19.2783 -1364 4 29.9814 27.5098 19.295 5.17179 -8.35919 5.46264 -1365 6 18.3573 9.54392 6.2041 9.96047 7.12844 39.1223 -1366 4 18.327 9.09374 5.37857 3.10343 -12.6247 -24.8999 -1367 4 19.1177 9.18386 6.70986 -9.9052 0.872737 -11.1311 -1368 6 21.018 30.3894 30.8381 -12.2875 -2.46479 40.1773 -1369 4 21.7266 31.0151 30.932 9.98027 8.24448 -8.07198 -1370 4 20.7269 30.28 31.7939 -0.642204 -5.24287 -40.3987 -1371 6 28.323 4.36597 15.0837 1.12527 39.8195 10.6489 -1372 4 27.8986 3.55092 15.2676 -12.4099 -32.2848 2.02696 -1373 4 29.0009 4.19376 14.4446 14.1396 -7.65384 -8.86362 -1374 6 12.7814 0.64254 16.5262 -20.2521 41.8336 -1.49998 -1375 4 13.0387 1.47629 17.0069 -1.64601 -27.4009 -13.133 -1376 4 12.0897 0.933072 15.8712 20.715 -4.46996 16.4219 -1377 6 27.5603 35.1844 8.24072 -26.8161 -1.20469 12.7263 -1378 4 28.0791 35.3455 7.47089 6.94403 2.76433 -19.537 -1379 4 26.8275 34.582 7.96906 18.9853 12.4469 9.56437 -1380 6 24.0704 5.17451 40.9985 43.9791 -14.9803 45.716 -1381 4 24.6298 5.96615 41.2045 -19.6374 -8.83437 -20.0494 -1382 4 23.3625 5.28724 40.4007 -22.1054 20.8081 -27.5224 -1383 6 16.8467 24.9145 28.3061 -32.8066 71.0274 -23.4158 -1384 4 15.8676 25.1613 28.454 39.6061 -31.4713 1.92714 -1385 4 17.0718 25.6559 27.6632 3.37355 -28.1253 20.4487 -1386 6 20.8411 12.7971 17.0095 43.3655 -24.1139 -5.17775 -1387 4 20.9692 13.6698 17.4217 0.0861137 -1.96629 -7.53612 -1388 4 21.7712 12.4167 16.7645 -47.1299 18.5523 16.3808 -1389 6 35.7683 23.0344 30.9263 1.08866 -13.108 5.55839 -1390 4 34.803 23.1301 30.928 3.64223 -3.31893 2.04139 -1391 4 35.9803 22.5404 31.7512 0.26244 15.2618 -11.5602 -1392 6 36.3065 21.404 25.8788 21.1988 16.3215 -11.4752 -1393 4 35.3711 21.2912 25.8279 -29.04 -8.19979 -7.71966 -1394 4 36.6742 20.6179 26.2596 7.44281 -15.7003 9.85929 -1395 6 13.4865 6.74911 5.29345 -32.6693 78.3701 45.7352 -1396 4 13.9616 6.05619 4.98306 41.5093 -80.328 -47.9816 -1397 4 12.7805 7.00791 4.71674 -14.9335 -5.37764 -13.3979 -1398 6 20.8104 20.4092 13.7653 1.99296 11.0688 -14.7475 -1399 4 21.268 20.4545 14.5989 11.9976 -3.76106 7.6647 -1400 4 19.8959 20.3184 13.9984 -15.4264 -4.27358 -1.02469 -1401 6 20.3637 29.125 1.38742 -7.39452 3.20569 15.6829 -1402 4 20.6257 29.8678 1.97015 -13.6171 -7.9879 -3.97808 -1403 4 19.4728 28.7955 1.69287 22.5847 10.4694 -9.78123 -1404 6 50.8792 13.1212 37.2655 -4.22961 23.9091 37.9372 -1405 4 51.3893 12.5589 37.8771 -2.47029 4.54984 -9.0483 -1406 4 50.5869 13.8674 37.8656 5.03029 -21.5284 -25.2034 -1407 6 33.9282 34.1694 20.494 -12.758 16.9363 4.62304 -1408 4 33.9505 34.3661 19.5368 -1.52487 0.481952 13.5649 -1409 4 33.2327 34.7631 20.901 14.0918 -19.53 -17.3949 -1410 6 26.2111 28.0581 27.5584 -15.6012 -12.4051 -9.62147 -1411 4 26.6887 28.3319 28.3498 -5.67664 4.83839 -0.885474 -1412 4 25.2376 28.0657 27.7416 20.5709 -1.16679 -1.23567 -1413 6 7.682 21.3042 4.28531 -31.6563 9.11884 52.3302 -1414 4 8.36407 20.9023 3.81015 41.1991 -18.6864 -33.8238 -1415 4 7.19271 21.9105 3.74865 -6.01459 10.7978 -19.2095 -1416 6 22.0049 15.1615 5.91526 -5.59087 32.8095 7.59658 -1417 4 22.5291 15.4011 5.14076 -1.79158 -8.25489 -6.60562 -1418 4 21.8369 14.2416 6.04435 2.97447 -25.4321 -3.26552 -1419 6 21.7136 24.0096 3.8157 22.5859 -13.9702 -11.1371 -1420 4 22.6792 24.1846 3.95073 -20.2229 4.30251 2.28349 -1421 4 21.6957 23.2604 3.18041 -1.04284 4.75891 13.5064 -1422 6 11.5672 23.7812 12.5534 10.6653 17.5289 -0.525849 -1423 4 11.8567 24.7317 12.4283 -11.704 -31.033 2.93832 -1424 4 11.2483 23.6794 13.4494 -5.02459 5.94744 7.15157 -1425 6 32.3679 18.058 29.8144 -2.59991 12.5874 27.6023 -1426 4 33.2958 17.8537 29.9681 1.40206 -2.08885 -2.88861 -1427 4 32.1708 17.8352 28.9168 3.64727 -16.5589 -23.8097 -1428 6 9.27501 12.3901 30.3257 8.89695 -9.73537 -4.18026 -1429 4 8.97738 13.0169 30.9954 -4.04452 2.00113 -0.0309771 -1430 4 10.1278 12.0418 30.6776 -19.7256 9.24572 -11.0885 -1431 6 40.1671 25.9203 9.1352 -31.1658 -6.55029 4.71016 -1432 4 40.7952 25.2818 9.45931 8.36253 -10.0667 -0.250848 -1433 4 40.6474 26.7215 9.01492 17.3912 21.2934 -6.4579 -1434 6 43.1616 32.3487 37.3267 7.45809 -19.2286 11.3512 -1435 4 42.8399 32.8446 36.5586 -11.2032 -5.45956 10.184 -1436 4 42.4733 31.7245 37.6799 8.3011 17.0164 -20.2151 -1437 6 44.0911 6.28198 31.259 8.64406 -6.47735 -33.2401 -1438 4 43.4563 6.84482 31.6606 -21.1773 24.4303 10.8162 -1439 4 44.5952 5.92873 31.9644 15.9286 -14.2375 24.3689 -1440 6 10.2063 18.8787 19.6978 14.6089 -0.63771 -2.74842 -1441 4 10.128 18.3979 20.5267 6.04825 -4.13467 -1.20166 -1442 4 9.36891 19.3219 19.635 -15.0357 8.38504 -1.1225 -1443 6 7.0561 15.5922 15.0299 -16.4573 19.9198 -23.3889 -1444 4 7.18612 15.4783 14.0721 1.05096 2.95086 4.94392 -1445 4 7.41457 14.833 15.4354 13.8635 -34.6267 13.25 -1446 6 24.544 3.4899 27.8655 -14.5565 -8.97091 -7.81951 -1447 4 23.6823 3.28725 28.2588 1.61952 11.0081 14.175 -1448 4 24.3729 3.16547 26.9791 10.0044 -2.74415 -7.35546 -1449 6 54.4109 31.8087 9.71194 -6.99911 23.6955 33.3298 -1450 4 53.8413 31.5567 9.00593 -8.22136 -4.9258 -26.1741 -1451 4 54.0752 32.6964 9.97695 10.2913 -15.383 -7.59421 -1452 6 6.81072 17.0817 36.2069 -39.6649 -0.569341 -18.8672 -1453 4 5.9036 16.7161 36.0961 17.2423 3.35707 18.397 -1454 4 7.03883 17.1994 35.2786 19.8939 2.17194 6.76773 -1455 6 28.6373 7.46216 20.4204 -3.00228 3.72915 -26.9716 -1456 4 27.791 7.71165 20.8314 -1.23568 -3.59083 -7.19581 -1457 4 28.5788 7.67124 19.4449 -3.89686 1.20908 30.1283 -1458 6 17.0427 1.7136 8.36469 -7.39711 4.96373 -17.441 -1459 4 16.9511 0.79552 8.17539 8.34993 -30.6792 14.2707 -1460 4 16.7364 2.03503 7.50962 2.58977 23.9868 7.32556 -1461 6 19.1319 19.334 35.5748 25.2315 11.3156 3.71898 -1462 4 18.4163 18.7293 35.4559 -12.7574 -15.0058 -3.77114 -1463 4 19.9108 18.8059 35.8312 -7.49406 2.79856 2.97864 -1464 6 7.31044 31.3665 13.5876 -12.5896 -10.3186 -18.1643 -1465 4 6.86348 30.5057 13.838 5.41483 30.5465 -8.86898 -1466 4 6.71656 31.9291 13.023 7.05746 -22.9991 7.02109 -1467 6 16.6555 5.24573 12.8486 0.44122 -36.1931 20.2204 -1468 4 17.4189 5.79101 12.9112 23.6003 17.0932 2.01526 -1469 4 16.8511 4.45507 13.4194 -12.0332 11.5633 -21.5138 -1470 6 43.8917 12.7482 34.58 -33.2024 -13.6106 -1.45858 -1471 4 43.9807 13.5999 34.156 2.60816 15.5254 -0.13451 -1472 4 42.9242 12.5381 34.5161 22.3754 -3.96122 -2.5942 -1473 6 42.656 36.4522 28.5282 -7.17959 22.9727 1.13167 -1474 4 42.279 37.3416 28.6522 -7.55712 -15.8866 -0.526154 -1475 4 43.5285 36.675 28.2003 16.3904 -10.8581 0.329061 -1476 6 35.3704 15.0467 6.02622 35.7531 43.3754 17.6476 -1477 4 35.9258 15.8884 5.86958 -26.5611 -35.5954 0.991204 -1478 4 34.7923 14.9488 5.27074 -5.69332 -0.0870189 -10.0798 -1479 6 19.4034 5.85396 6.19026 -42.6676 -37.2433 -25.4755 -1480 4 18.4973 6.11578 6.46985 14.7962 -6.51198 7.73248 -1481 4 20.0178 6.47164 6.48735 29.6225 43.4574 23.1864 -1482 6 29.2636 38.16 6.98139 -51.0091 34.2659 0.167673 -1483 4 28.4794 38.0546 7.56687 16.6219 5.90534 -14.0005 -1484 4 29.8812 37.5458 7.29338 34.0617 -33.3732 10.6718 -1485 6 19.3639 26.1879 8.4772 -1.75021 -19.5484 18.4946 -1486 4 19.3765 25.7536 9.37133 0.505418 11.6152 -20.7618 -1487 4 20.132 25.8039 8.02679 -2.64689 1.58972 6.88257 -1488 6 4.91801 16.6546 6.12902 16.8332 -1.31437 8.04366 -1489 4 5.58152 17.3 5.84506 -6.45866 4.1219 -0.991793 -1490 4 5.39084 15.8022 6.09449 -7.75564 17.9483 -2.53018 -1491 6 6.07873 16.6931 28.0679 20.4204 4.35008 -35.2212 -1492 4 5.19925 16.4426 27.8453 -29.7482 -9.15572 9.47762 -1493 4 6.44387 16.7631 27.1426 -3.77999 2.92972 38.3228 -1494 6 21.7313 29.3584 22.0941 -19.989 26.599 40.0594 -1495 4 21.5191 30.3374 22.0902 3.30888 -28.6715 -0.0155919 -1496 4 21.2646 29.0087 22.9228 20.4195 8.84702 -28.341 -1497 6 24.487 0.545827 12.8459 24.5625 -19.0276 8.44191 -1498 4 24.0381 0.883409 12.0817 -9.22903 10.6064 -10.7293 -1499 4 24.0836 0.980384 13.5911 -6.14963 8.46579 8.44801 -1500 6 18.4109 28.2545 40.3162 -15.9129 36.5713 -32.2972 -1501 4 18.3366 27.7076 41.0573 0.952339 -31.6797 34.0712 -1502 4 19.1875 27.9677 39.8503 10.0284 -2.61836 -5.50219 -1503 6 10.3807 17.4604 21.8947 -1.20821 -16.3296 3.13877 -1504 4 9.80057 16.6779 21.8113 10.8468 3.86983 1.60142 -1505 4 10.0443 17.9356 22.6521 -9.33664 9.03137 6.2204 -1506 6 13.5404 13.3591 39.6327 12.5768 11.767 30.0264 -1507 4 13.9188 14.1992 39.2886 -9.97897 -11.5724 13.3172 -1508 4 13.5464 13.3749 40.6413 1.33606 5.90172 -38.0522 -1509 6 19.5508 26.0247 24.7387 -47.8665 -1.21537 -13.2845 -1510 4 19.6189 25.3328 24.097 -5.62542 -9.91951 -19.3965 -1511 4 20.3649 25.9852 25.1641 45.3739 3.88293 31.7071 -1512 6 8.93445 25.8823 20.0822 -10.4543 -29.9419 8.18251 -1513 4 8.35083 26.4773 20.5043 -33.2288 11.519 27.1484 -1514 4 9.504 26.5029 19.6962 43.6798 16.1155 -28.0388 -1515 6 13.4493 41.2138 30.5102 -4.84662 -36.1256 25.75 -1516 4 14.2597 41.094 31.0483 -5.58856 8.18726 -8.9115 -1517 4 12.8416 40.5025 30.8796 12.8197 27.661 -18.9522 -1518 6 21.1596 21.6794 11.1163 10.7366 20.8259 2.41134 -1519 4 20.9554 20.8709 10.6777 -10.2383 -24.5438 -10.817 -1520 4 21.2276 21.4421 12.046 -2.84377 -3.57945 5.82209 -1521 6 43.5643 10.3136 15.5616 17.5969 -21.741 5.94749 -1522 4 43.2379 9.48961 15.149 2.99942 14.1859 3.68588 -1523 4 42.9802 11.0242 15.3396 -21.8087 10.2132 -10.2755 -1524 6 23.5302 5.07333 12.3088 -23.5628 55.8128 -25.3063 -1525 4 23.4112 4.1923 12.0373 1.19089 -49.3933 -5.08619 -1526 4 23.0178 5.53904 11.5656 24.5614 -12.3881 30.382 -1527 6 9.28539 15.401 4.24759 1.63269 -5.62651 -9.8947 -1528 4 9.02922 16.1115 4.82738 -12.4128 14.4693 4.40189 -1529 4 9.90895 14.9318 4.78697 15.8319 -9.58935 3.85081 -1530 6 26.711 10.8797 17.566 5.43365 -10.3343 -26.0937 -1531 4 26.4818 11.0142 18.4585 -6.06422 3.32013 41.5711 -1532 4 26.8019 11.7518 17.1937 0.341074 3.88847 -5.26754 -1533 6 26.0592 23.5875 33.6794 25.1455 50.9154 21.2543 -1534 4 25.4682 24.0785 33.1024 -8.24785 -6.01089 -9.80751 -1535 4 26.6604 24.3213 34.0779 -26.6739 -38.162 -12.8336 -1536 6 7.57385 10.4949 28.9097 -14.7972 2.07126 0.456687 -1537 4 6.75277 10.5859 29.4011 -5.17598 -12.8295 -3.89358 -1538 4 8.06091 11.2035 29.3139 24.0536 5.38729 3.77373 -1539 6 16.4953 16.9073 24.6459 13.4535 22.6993 31.6086 -1540 4 15.9363 17.7011 24.6942 7.46422 -1.49957 -9.096 -1541 4 16.1467 16.4045 23.9375 -12.5815 -17.1437 -28.632 -1542 6 12.5505 12.7927 0.441559 26.7797 -18.4986 61.4448 -1543 4 12.8902 12.7839 1.42408 -16.6807 15.1369 -51.7767 -1544 4 12.972 11.9767 0.117581 -17.3776 3.59908 -10.4186 -1545 6 6.80454 2.46926 9.04378 10.3033 -16.1572 19.5551 -1546 4 7.05376 2.92505 9.85651 -1.04006 9.78535 -3.84035 -1547 4 7.36555 1.67892 9.06596 -6.07141 -1.3767 -9.09165 -1548 6 28.8788 11.8454 12.005 47.3119 33.3239 7.75537 -1549 4 28.2175 12.4307 11.6211 -4.89696 7.77957 0.00959457 -1550 4 29.7805 12.2922 11.8721 -37.0304 -14.6121 1.30522 -1551 6 44.6756 32.5924 29.7091 -46.8228 -4.47104 18.0754 -1552 4 43.7214 32.9254 29.5641 42.8383 -8.78111 -1.84094 -1553 4 44.558 31.8742 30.3802 4.31467 20.1075 -17.1439 -1554 6 28.6099 15.1189 32.288 -8.09168 -64.7739 -6.10589 -1555 4 29.0591 15.887 31.9855 13.2175 18.1439 -15.8441 -1556 4 29.0109 14.3064 31.825 -10.272 37.9041 18.9788 -1557 6 1.13952 22.1955 33.6303 -59.4889 25.247 28.7943 -1558 4 0.675447 22.8098 33.0333 5.4615 -9.68619 7.91413 -1559 4 1.8611 21.9185 33.1521 52.5767 -22.4691 -40.0321 -1560 6 17.4529 16.8222 9.92046 -20.0761 -24.0842 48.1247 -1561 4 17.9341 17.1517 9.19999 21.5054 13.464 -32.8219 -1562 4 17.9802 16.1035 10.3295 -2.40424 8.44812 -14.2536 -1563 6 18.74 29.8021 14.3918 16.1488 4.65404 69.9188 -1564 4 19.5966 29.6355 14.8679 -24.5899 1.22938 -11.6521 -1565 4 18.9027 29.6655 13.4911 13.4763 -5.12933 -46.2854 -1566 6 39.4106 6.51176 13.0171 8.18439 9.54271 -9.98348 -1567 4 39.7968 7.3217 12.6105 -7.82756 -18.4389 5.68309 -1568 4 39.8965 5.76959 12.6221 -1.11983 7.69721 6.02388 -1569 6 54.1122 38.2735 14.316 -26.3921 15.7841 23.5556 -1570 4 53.5092 38.7211 14.9446 14.1224 -15.8084 0.476194 -1571 4 53.7657 38.6747 13.5269 5.67525 0.359642 -25.5906 -1572 6 7.51656 32.0218 20.9281 34.7748 10.0158 34.1931 -1573 4 7.08362 31.9253 20.1193 -22.6959 2.07513 -43.8223 -1574 4 7.03544 31.4175 21.4603 -12.2713 -14.4046 24.4342 -1575 6 26.9722 15.5137 13.836 8.2831 -9.07996 -12.1546 -1576 4 27.2905 14.6773 14.2204 -10.3825 7.39938 7.42218 -1577 4 26.0228 15.629 13.9568 -6.27371 -3.74993 11.5294 -1578 6 18.3731 16.4369 32.1258 -5.47484 6.15837 -16.1574 -1579 4 18.1737 16.7054 31.2071 -0.945967 -8.38127 9.44724 -1580 4 19.0036 17.0959 32.4159 12.6478 4.85619 3.13766 -1581 6 52.4904 31.6749 23.2282 -45.8236 3.94874 65.5164 -1582 4 52.5054 32.2301 24.055 -6.11863 -14.7847 -21.5508 -1583 4 53.2278 31.9578 22.7624 44.676 11.2926 -39.5338 -1584 6 2.17063 9.69676 28.2025 -10.599 22.0242 17.0864 -1585 4 2.41083 10.574 27.888 12.6445 -0.15763 -12.1006 -1586 4 1.36653 9.91172 28.7063 1.66945 -10.1846 4.32482 -1587 6 32.9295 0.084333 22.579 -26.8721 -17.4052 -13.8633 -1588 4 33.2309 41.109 22.2818 0.690852 17.8844 8.89147 -1589 4 33.6446 0.598803 22.932 23.7791 -0.031599 0.0852179 -1590 6 20.7171 41.5453 38.643 51.9522 19.855 -62.1487 -1591 4 20.0643 41.0408 39.0691 -29.2365 -22.9372 13.5286 -1592 4 20.9788 41.0468 37.7869 -12.0924 18.2625 49.3819 -1593 6 43.2965 24.3242 12.1559 29.4143 27.7167 -28.3716 -1594 4 43.2964 25.2918 12.2975 -10.3211 -14.9579 7.88207 -1595 4 44.0244 24.2792 11.4826 -12.2932 -11.2644 22.4039 -1596 6 22.0333 36.2992 11.8143 -17.8744 11.1706 -5.23693 -1597 4 21.6038 36.9407 11.2131 12.0614 -9.84488 11.7859 -1598 4 22.8639 36.0559 11.3996 4.49067 -2.6397 -1.6843 -1599 6 50.7446 20.5307 30.3299 -19.4296 24.1009 0.394401 -1600 4 50.3769 20.0585 31.0978 -4.60399 -0.499453 -6.82258 -1601 4 50.1204 21.2977 30.1594 19.9431 -26.9935 4.34337 -1602 6 20.8379 3.84934 18.1872 -10.63 2.24574 17.9634 -1603 4 21.6372 4.15439 17.7675 6.81748 4.13844 -2.44268 -1604 4 20.7537 4.31685 19.0447 1.53322 -4.30004 -12.0579 -1605 6 4.001 20.6421 6.99361 -18.7611 -9.71733 3.72301 -1606 4 3.09723 20.6004 6.53941 30.5715 -8.65918 22.3858 -1607 4 4.00786 20.2035 7.89591 -15.2068 14.2544 -28.772 -1608 6 11.948 15.4413 41.4409 9.86263 -45.3449 -5.39948 -1609 4 11.9713 14.4541 41.6361 -2.32711 35.624 3.02695 -1610 4 12.4708 15.4889 40.6181 -5.28805 11.0492 6.42 -1611 6 3.00764 18.5435 38.9252 6.90717 -29.584 40.0663 -1612 4 3.56523 17.7255 38.8717 -9.75827 16.9893 -1.25399 -1613 4 2.92934 18.9138 38.0721 -1.66709 15.3109 -35.9518 -1614 6 8.5978 38.8858 11.3072 48.4025 32.5603 4.46589 -1615 4 9.44036 39.0024 10.7943 -20.5341 -1.07382 9.55064 -1616 4 8.19448 38.1327 10.9484 -22.3544 -46.6733 -17.9601 -1617 6 12.9691 33.9778 38.4933 34.8069 -13.3685 -21.4899 -1618 4 12.6573 33.2385 37.9471 -9.06758 1.22663 10.2849 -1619 4 13.9307 33.983 38.2659 -20.4066 10.3952 14.8996 -1620 6 4.69069 11.9902 6.04709 5.57568 0.955193 2.63183 -1621 4 3.83092 11.6207 5.79405 1.19943 -2.71585 -3.65246 -1622 4 5.36696 11.7708 5.36999 -19.9658 -4.94035 2.87891 -1623 6 10.8381 15.9154 25.2196 -36.4648 2.02786 -4.38258 -1624 4 11.7191 16.2167 25.3262 31.8449 11.9168 5.4517 -1625 4 10.3518 16.6682 24.8476 5.65772 -8.76316 -0.529027 -1626 6 20.7604 3.23767 6.55488 4.15603 28.9608 0.670607 -1627 4 20.2106 2.56517 6.18958 -7.79877 -24.0058 -5.45951 -1628 4 20.2434 4.04703 6.45055 -2.36445 1.41903 2.77062 -1629 6 47.6381 39.1588 31.2153 -11.506 28.7103 -40.9212 -1630 4 46.7125 39.0803 30.8864 16.1685 3.01672 12.9065 -1631 4 48.0161 39.883 30.6238 -10.851 -36.2784 24.6994 -1632 6 8.33868 27.7571 27.6932 -33.938 3.65348 13.4266 -1633 4 7.90796 26.9962 28.1436 6.90464 18.5991 -0.450451 -1634 4 9.05762 27.3551 27.2376 19.8804 -10.068 -12.1598 -1635 6 33.245 40.3099 33.4253 18.3517 22.2199 -28.9554 -1636 4 32.5937 41.0038 33.2194 0.94932 -12.4457 9.89811 -1637 4 33.9479 40.492 32.7526 -7.59275 -9.33057 17.0692 -1638 6 24.5058 34.6327 27.2588 -1.70215 14.4876 -27.3243 -1639 4 24.8356 35.5409 27.0166 -5.53884 -24.0927 13.0812 -1640 4 24.1351 34.315 26.3934 7.47117 3.95694 29.9195 -1641 6 13.3256 36.76 35.7403 23.371 22.3884 -21.319 -1642 4 14.292 36.6204 35.8687 -19.0607 -2.42845 14.454 -1643 4 12.8134 36.0651 36.1242 -8.79549 -23.1532 9.33092 -1644 6 34.0568 20.1616 33.2139 18.2744 1.49148 -3.34215 -1645 4 34.901 20.3965 32.7524 -27.9907 10.0382 9.43414 -1646 4 33.5726 20.9405 33.5892 13.555 -8.0917 -8.63642 -1647 6 22.8329 33.5616 31.6214 -12.6844 15.5573 -21.5595 -1648 4 23.5755 34.1858 31.5969 1.53708 -3.14405 -0.637663 -1649 4 23.0292 32.8658 32.2325 13.4469 -12.4025 17.113 -1650 6 23.7434 2.42786 19.8498 9.49596 22.5629 12.9133 -1651 4 24.532 1.90722 19.7117 15.1933 -8.07802 -2.32773 -1652 4 23.0629 1.99408 19.3682 -23.4605 -15.8437 -14.4607 -1653 6 10.59 1.63974 20.5169 -0.95575 -6.83071 6.14558 -1654 4 9.98705 1.03236 20.0473 7.71399 2.84727 3.14747 -1655 4 10.6246 2.47233 20.0276 -8.35822 1.7372 -3.87231 -1656 6 6.50082 24.8628 7.81243 5.63459 3.09475 -4.38693 -1657 4 7.40706 24.9537 7.44087 -14.825 -10.0154 1.3351 -1658 4 6.01351 24.1359 7.38457 10.3118 5.93376 -6.27471 -1659 6 54.7907 32.5298 25.4601 2.42441 14.1538 -12.299 -1660 4 54.0693 33.194 25.3949 12.697 -15.3913 -0.923548 -1661 4 0.387469 32.6052 24.6546 -22.4501 -0.197402 25.3904 -1662 6 6.24565 20.1804 28.9699 -20.0835 16.2671 13.5362 -1663 4 5.37616 20.2206 28.5173 17.3942 -4.89439 1.50138 -1664 4 6.85708 19.7029 28.4106 5.94408 -11.9876 -6.03836 -1665 6 50.061 21.6087 11.3404 -11.515 44.0552 -42.0488 -1666 4 50.9725 21.751 11.0493 2.56545 -3.3262 -1.97817 -1667 4 50.0662 20.9568 11.9903 8.13397 -42.2403 36.0281 -1668 6 43.4741 33.5215 19.648 39.1267 -7.16957 -40.9914 -1669 4 43.8052 33.5504 20.5247 -1.27694 2.64583 28.8889 -1670 4 42.5461 33.5822 19.6063 -36.855 5.29583 12.3512 -1671 6 30.8225 7.19458 41.0729 -33.0718 18.8928 10.1641 -1672 4 30.0173 7.64992 40.6345 32.3343 -18.9847 22.962 -1673 4 30.7853 7.47469 0.131591 -1.52838 -8.42988 -38.7943 -1674 6 12.1264 25.8478 11.0965 -41.5825 -1.76886 -24.0951 -1675 4 11.2804 25.9828 10.5746 22.2453 -8.09118 27.7312 -1676 4 12.6111 26.6214 10.8799 25.9351 22.819 -1.42381 -1677 6 47.8207 5.82713 17.7363 28.7614 -16.7343 -8.46055 -1678 4 48.0335 5.15295 17.0353 -2.74159 24.5551 13.4979 -1679 4 48.6986 6.12754 18.0988 -19.3132 -4.26463 -8.98138 -1680 6 35.1697 12.9074 16.5814 -26.6969 23.1645 14.7724 -1681 4 35.331 12.9801 17.5341 9.94288 -5.95548 -5.31324 -1682 4 34.5116 13.6489 16.4838 18.7069 -22.8028 -11.189 -1683 6 10.4746 10.6344 33.9856 -30.1195 -20.4446 -6.31426 -1684 4 10.7944 11.3866 34.5009 -4.55531 -6.56386 0.452866 -1685 4 9.59186 10.377 34.349 25.6427 10.4215 -3.60637 -1686 6 9.86976 7.46809 9.66723 13.2706 -15.2427 -11.6817 -1687 4 9.07254 8.00079 9.6953 0.322066 10.4083 -1.78771 -1688 4 10.1027 7.29929 8.72005 -15.6005 8.2826 19.6359 -1689 6 11.1498 9.5629 29.1446 -4.60031 -6.3451 3.75047 -1690 4 10.6862 9.26798 29.9509 5.10767 2.07156 -10.4371 -1691 4 11.3249 8.76682 28.6116 2.75639 0.845127 6.4689 -1692 6 46.3982 12.7571 37.8973 13.0728 8.65129 -14.0384 -1693 4 46.6651 13.0033 36.9771 -6.5436 -6.98702 17.4091 -1694 4 46.8422 13.384 38.4935 -4.33131 -5.25976 0.421567 -1695 6 4.7745 19.0249 15.9997 -22.3762 2.96494 22.3523 -1696 4 4.16029 19.0173 16.7572 4.82074 7.85299 -8.34635 -1697 4 5.51792 18.5695 16.4006 17.242 -3.98645 -13.636 -1698 6 50.2756 39.8187 19.3535 -48.7732 -19.7782 -8.19609 -1699 4 50.1357 39.0812 19.9713 14.3147 6.83039 4.1366 -1700 4 49.4547 39.7468 18.7938 35.5854 8.27631 5.22634 -1701 6 3.57022 23.2982 26.3116 -7.21736 12.7853 -4.33091 -1702 4 3.04677 23.327 25.4841 2.15403 -9.28995 15.8001 -1703 4 3.1589 23.9918 26.8774 3.27351 -16.4313 -7.87876 -1704 6 43.3323 18.2357 20.5099 -9.76971 -1.121 -6.56922 -1705 4 42.7632 18.9863 20.7177 2.34101 2.93749 0.115163 -1706 4 43.9096 18.122 21.2711 1.48233 -4.92166 7.17918 -1707 6 14.4939 41.5272 19.7194 7.33174 -3.95938 -8.98841 -1708 4 13.9791 41.768 20.4704 -25.804 7.49044 14.4407 -1709 4 15.35 41.4773 20.1189 24.9681 -5.23262 -6.74673 -1710 6 29.2751 29.8624 26.915 55.5011 14.3278 -64.7852 -1711 4 29.462 29.6739 25.9095 -28.0317 9.76644 54.5148 -1712 4 30.1137 30.3565 27.1616 -29.5885 -20.0698 8.89328 -1713 6 6.32585 26.1455 11.5441 3.18215 15.5722 27.8672 -1714 4 6.22913 25.7559 12.4173 -5.87839 -9.43723 6.04013 -1715 4 6.88652 26.9071 11.7431 3.72153 0.148286 -16.8953 -1716 6 27.6581 9.23325 15.2376 24.6795 20.4415 1.81178 -1717 4 28.3906 9.86787 14.9946 -20.7277 -22.2866 6.02651 -1718 4 27.7257 8.49599 14.6233 3.42822 -3.8556 -2.27597 -1719 6 29.7826 38.0629 17.0951 -21.7625 -1.10982 -31.3954 -1720 4 29.5447 37.2807 16.5438 11.5646 7.7876 16.1146 -1721 4 29.1666 38.7512 16.7768 9.10566 -6.75007 12.2127 -1722 6 52.2237 28.7307 4.26632 40.7154 12.5569 -19.536 -1723 4 53.094 28.6942 3.75761 -25.982 6.02481 23.1744 -1724 4 51.8384 27.8718 4.17524 -3.40498 -27.0863 -4.04919 -1725 6 17.1651 16.6761 6.10093 10.0081 29.999 -15.4838 -1726 4 17.0645 17.5224 6.60658 -3.46995 -23.4179 -4.25622 -1727 4 16.9429 15.9406 6.65512 -3.52922 -13.7209 19.1007 -1728 6 36.6584 7.55275 33.426 1.51046 -27.4434 34.6673 -1729 4 36.0562 7.00422 33.9909 9.38132 12.247 -13.9906 -1730 4 36.0891 7.78594 32.7139 -15.8398 12.8789 -25.2624 -1731 6 26.1693 3.13272 9.58463 26.4836 36.1065 -53.3475 -1732 4 26.5189 3.61335 10.3026 12.8321 10.8542 33.1136 -1733 4 25.6805 2.43597 9.90138 -37.6231 -51.1462 30.1839 -1734 6 1.19232 17.1076 33.1734 0.722887 26.1228 -9.87087 -1735 4 1.0219 17.7977 32.4875 3.44775 -13.3597 11.6369 -1736 4 0.89275 17.4757 34.0242 -0.842403 -4.58413 -3.86686 -1737 6 29.175 10.1805 5.37687 2.48705 -7.47299 -1.58449 -1738 4 28.5307 10.3443 6.0806 2.54341 -1.49901 -0.102048 -1739 4 29.6529 9.35261 5.56356 -13.9845 3.47491 -0.693848 -1740 6 9.21964 21.135 0.193729 30.6013 -8.57211 -16.2038 -1741 4 9.93935 20.7152 41.5745 -5.21063 7.9265 20.924 -1742 4 8.4582 20.7874 41.6647 -18.4316 -1.36421 1.54976 -1743 6 7.41915 26.897 34.8578 6.273 24.0322 40.4596 -1744 4 7.07209 27.1094 35.7714 11.2799 -9.18849 -34.7736 -1745 4 6.87885 26.1925 34.5434 -18.5272 -22.724 -11.5995 -1746 6 18.6237 10.1563 3.02822 -55.9716 37.9013 1.68891 -1747 4 17.9823 9.44023 2.87563 14.9297 4.34306 1.98909 -1748 4 18.009 10.9755 3.18254 40.8652 -32.8317 -2.61569 -1749 6 13.1455 21.2337 25.2154 -14.3081 5.93545 -14.9534 -1750 4 12.8153 21.6822 24.4216 9.6722 -4.26313 4.93127 -1751 4 12.7862 20.3541 25.1726 -3.49479 -14.4912 -0.313259 -1752 6 4.91031 24.4198 40.532 -13.7809 -26.5024 -53.169 -1753 4 5.65778 24.4539 41.0894 26.3299 12.2697 26.6549 -1754 4 5.26856 23.9753 39.7091 -18.4358 16.5303 24.5031 -1755 6 54.7198 6.2862 9.93073 18.558 2.67796 -18.7732 -1756 4 54.1336 6.00192 10.611 -15.308 -5.80798 23.6242 -1757 4 0.005563 7.17106 10.1764 0.43073 7.36928 5.10877 -1758 6 51.7604 16.6436 19.3877 -20.3234 -7.55047 -14.8495 -1759 4 51.6779 16.1639 18.5383 1.1676 14.9854 4.84802 -1760 4 52.2077 17.4816 19.2574 16.3674 3.30585 -9.00164 -1761 6 38.6218 2.96001 13.0988 15.7387 3.67705 55.5859 -1762 4 38.6299 3.43096 13.9849 -4.06073 -12.9308 -23.724 -1763 4 38.2169 3.56793 12.5083 -12.8186 19.7945 -24.9943 -1764 6 19.4471 35.7007 9.61167 2.35324 -8.95281 6.35471 -1765 4 18.8335 36.2871 9.19379 -17.9936 2.63552 -14.7984 -1766 4 18.9495 35.3837 10.3842 8.56204 6.47345 -9.11173 -1767 6 46.9457 37.6212 25.7021 -15.6754 4.57489 10.5165 -1768 4 47.0239 38.0262 24.8354 11.6036 -0.197794 -10.4287 -1769 4 47.7281 37.1166 25.9279 8.14222 -0.129186 -6.11913 -1770 6 20.0249 17.2708 14.7582 9.34392 -2.11639 -6.02108 -1771 4 19.1723 17.4786 15.1706 12.7461 -0.873648 3.80655 -1772 4 20.7009 17.0069 15.4035 -13.3418 2.74043 0.572405 -1773 6 24.7358 29.2923 3.78206 18.5642 -33.4808 -47.1325 -1774 4 24.7422 28.3915 3.3709 -13.1038 11.8323 28.3161 -1775 4 25.3506 29.6775 3.14782 -2.77927 21.1078 10.4189 -1776 6 3.43141 8.92567 6.82668 25.8011 -1.75535 29.9445 -1777 4 3.08486 8.82716 7.75964 16.0017 4.22665 -30.6726 -1778 4 4.42441 9.10783 6.89545 -42.5611 -5.30748 1.54274 -1779 6 17.4891 30.59 19.7026 37.1524 -11.5388 -6.241 -1780 4 18.4343 30.3591 19.4199 -38.2372 10.1448 10.4771 -1781 4 16.9657 29.7875 19.5831 -4.14236 3.18225 -9.29444 -1782 6 13.2748 16.1833 39.0603 8.39615 -10.6604 2.01333 -1783 4 13.778 16.9491 39.3364 8.93523 3.59341 7.63718 -1784 4 12.5498 16.5465 38.5646 -17.693 7.52452 -10.3405 -1785 6 23.8419 27.9652 11.5971 -29.0622 15.8949 5.8355 -1786 4 23.0433 27.5239 11.9581 15.8216 -1.64981 -8.50246 -1787 4 23.6687 28.8945 11.8451 9.38175 -9.8305 -3.59643 -1788 6 14.4582 24.411 21.2251 -13.2323 27.0215 19.0701 -1789 4 13.9163 25.2229 21.3861 13.2503 -9.35589 -12.2275 -1790 4 14.348 23.9323 22.0593 -1.27999 -3.95586 -5.82862 -1791 6 46.6209 15.1404 22.2877 -21.0909 8.30909 34.5316 -1792 4 45.8336 14.7024 21.9608 7.3328 -3.88381 -14.3297 -1793 4 47.2246 15.4169 21.6106 10.5055 -5.27886 -22.0515 -1794 6 19.1453 29.7169 11.8746 -27.0123 -18.8736 -35.9167 -1795 4 18.7667 30.5363 11.5796 10.8323 29.6783 4.39578 -1796 4 18.5214 29.1838 11.3275 23.3568 -13.7991 20.8336 -1797 6 36.9132 18.8016 27.615 -17.0652 -23.8487 30.8874 -1798 4 36.4034 18.4868 26.8464 6.26881 1.65463 6.80847 -1799 4 36.6041 18.1666 28.3506 10.215 31.7365 -33.4968 -1800 6 35.8839 17.5137 25.5036 -5.81764 30.7264 -16.7466 -1801 4 36.5665 17.9094 24.9 -10.7703 -22.5287 9.19997 -1802 4 35.9135 16.5474 25.44 8.68204 5.15754 -2.43364 -1803 6 8.04468 41.8981 31.5366 26.4021 9.77217 -3.38911 -1804 4 8.66886 41.284 31.9946 -24.4733 15.0027 -13.0466 -1805 4 8.60227 0.704634 31.1522 -11.4596 -14.2431 6.13083 -1806 6 31.7024 34.8356 17.9299 26.5575 -27.0845 -4.88708 -1807 4 32.6196 34.4986 17.7931 -22.3662 0.836155 -3.84042 -1808 4 31.9071 35.6664 18.3392 -5.09232 26.8034 6.09861 -1809 6 22.0993 41.0535 5.13739 10.0927 40.3608 -89.4928 -1810 4 22.1435 40.6782 5.94278 2.96748 -46.7441 88.004 -1811 4 22.8097 40.6452 4.60918 -8.49191 2.25551 6.5005 -1812 6 11.6188 5.17183 29.5438 -37.4391 -17.3681 45.4318 -1813 4 12.0782 4.3477 29.7115 12.4576 1.56532 -11.0695 -1814 4 10.8376 5.06958 30.1835 21.3256 14.0691 -33.8944 -1815 6 13.0142 9.45267 21.0738 -17.3871 -39.5803 -33.4019 -1816 4 13.648 9.91302 21.5572 37.1542 33.3127 26.6408 -1817 4 13.4951 8.71823 20.6397 -14.9934 11.5246 2.17133 -1818 6 12.4259 4.16416 0.171584 25.5917 58.0572 -18.9009 -1819 4 12.7038 3.75631 0.988868 -0.121161 -3.62646 8.37405 -1820 4 12.9914 5.02921 0.073462 -27.1162 -49.1387 2.0493 -1821 6 45.1548 14.6294 28.1056 43.5869 -15.7342 -2.79686 -1822 4 45.3799 14.9442 27.2254 -14.4652 2.82802 -6.08545 -1823 4 46.001 14.1543 28.294 -26.1128 6.03561 5.66217 -1824 6 52.5819 19.2522 0.880939 -13.6546 -24.4625 3.21793 -1825 4 52.4967 19.3157 41.8353 6.16951 -6.72877 -2.3034 -1826 4 52.7342 20.1258 1.1855 8.55196 28.2584 6.16427 -1827 6 0.17636 18.5769 30.5692 -13.5341 -21.3209 11.3545 -1828 4 0.97347 18.6538 30.0344 3.16555 8.74201 -0.550561 -1829 4 54.7381 19.4288 30.6755 1.51483 11.9419 -1.05075 -1830 6 17.6474 28.1849 1.96582 -3.95698 7.79984 2.09024 -1831 4 17.0036 28.8884 1.72628 7.01161 -11.1903 7.18073 -1832 4 17.5665 28.0879 2.93205 1.48476 5.36119 -8.9874 -1833 6 22.5179 30.1562 5.01973 -0.557011 13.5756 -11.2394 -1834 4 23.053 30.1464 4.21842 7.71181 1.56353 5.86697 -1835 4 22.1417 29.2826 4.9966 -11.5089 -8.75783 6.0437 -1836 6 11.3992 8.80614 17.6425 18.8049 17.2909 -5.92301 -1837 4 12.0044 8.1818 18.0403 -8.94801 -14.7479 17.6102 -1838 4 12.0653 9.44286 17.3244 -18.8797 1.15675 -4.46111 -1839 6 32.2825 3.5901 26.8335 38.6865 42.7422 0.354813 -1840 4 31.9744 3.38447 25.9652 -16.937 -9.17442 -22.5821 -1841 4 32.8531 4.41036 26.697 -18.7333 -32.0278 -1.10411 -1842 6 26.8283 37.1448 15.664 9.9544 44.9512 -6.81835 -1843 4 26.832 37.6522 16.5019 -4.80771 -22.2764 -7.00776 -1844 4 26.708 36.2069 15.7377 -4.77442 -21.1488 11.5765 -1845 6 22.9466 3.40402 22.281 26.551 -3.46013 -1.27592 -1846 4 23.3626 3.00539 21.4748 -15.0613 6.75 14.6032 -1847 4 23.702 3.67884 22.8406 -14.5661 -4.86975 -12.1571 -1848 6 14.6187 28.2219 5.2011 12.2375 -1.31522 5.54773 -1849 4 14.146 28.1316 4.37141 -5.71124 1.87741 -8.30492 -1850 4 14.2863 29.0052 5.66137 -0.824291 -0.470469 -2.06805 -1851 6 20.2555 37.1856 16.5486 -24.9193 16.4856 21.7008 -1852 4 21.0596 37.4718 16.144 26.6499 6.5165 -11.4453 -1853 4 20.1477 37.8155 17.2956 -4.48599 -12.7862 -6.90992 -1854 6 17.9469 28.5629 23.8891 26.0841 -15.2841 -12.8531 -1855 4 18.7956 28.2639 23.4837 -20.5944 5.95667 14.8805 -1856 4 17.3322 27.8283 23.7208 -3.07308 9.52654 -1.59768 -1857 6 33.6454 24.2344 25.2281 6.08515 -19.3492 9.67379 -1858 4 33.7229 23.2583 25.1621 -7.7165 13.5894 -11.682 -1859 4 33.9838 24.3464 26.1231 0.527101 9.69022 -3.14208 -1860 6 9.99248 17.6305 2.22889 -2.94775 -31.1618 -12.577 -1861 4 10.7668 17.5307 1.6348 -7.17319 1.58445 12.7603 -1862 4 9.8062 16.7546 2.64219 6.61617 15.6433 -4.64734 -1863 6 24.3378 36.7975 8.92134 10.0949 -17.5556 18.6285 -1864 4 24.0798 37.5812 8.46711 -7.4438 24.0622 -5.98172 -1865 4 24.7733 37.0584 9.7453 -6.84359 -4.10885 -5.58351 -1866 6 14.3929 4.30304 27.7402 56.7365 -3.53996 19.7179 -1867 4 15.3546 4.44499 27.4586 -37.3153 -7.57895 7.00929 -1868 4 13.8272 4.37832 26.9899 -16.116 5.01688 -19.8092 -1869 6 13.2096 25.4586 35.3298 -3.87145 -6.51473 -10.8119 -1870 4 13.1476 25.2267 36.278 -1.83966 -3.78777 -13.8323 -1871 4 12.5545 24.9939 34.7684 5.09589 5.85633 19.2997 -1872 6 43.7315 33.1816 24.4051 17.2004 -9.02075 24.8986 -1873 4 44.3591 33.0681 25.1678 -20.1541 -6.26738 -17.3644 -1874 4 44.1096 33.9146 23.9227 -1.6352 8.32092 -8.69406 -1875 6 6.97009 30.4077 7.13769 23.121 1.43384 34.0809 -1876 4 6.71282 29.9591 7.9596 7.06976 3.62274 -2.26904 -1877 4 6.20421 30.2819 6.61977 -27.9511 -2.76807 -27.2062 -1878 6 44.437 39.4145 21.7835 -9.43682 11.6365 -18.5611 -1879 4 43.878 39.1032 21.0489 1.92512 -11.9494 17.5009 -1880 4 44.878 40.1639 21.3648 8.44417 -6.89071 6.17346 -1881 6 1.1648 16.4475 24.9778 -2.61131 5.39938 13.1681 -1882 4 1.07525 17.0286 24.1819 -7.88043 -13.0173 22.3573 -1883 4 0.434843 16.5677 25.6378 18.4556 1.9359 -28.7216 -1884 6 8.16988 33.8361 10.6637 16.6829 23.9256 47.7562 -1885 4 8.49559 33.5478 9.83195 -4.50358 -22.2449 -29.7436 -1886 4 7.35799 33.4028 10.9227 -18.4601 -13.1254 -8.86092 -1887 6 45.3716 15.8699 40.491 -6.36942 -3.03704 -2.15917 -1888 4 44.5133 15.7719 40.0601 4.63234 -6.98635 -0.416374 -1889 4 45.243 16.6248 41.0649 5.7116 1.92459 5.42472 -1890 6 38.7776 4.29245 15.9056 11.0795 0.30753 4.41463 -1891 4 39.6766 4.00679 16.0952 1.69097 -2.92337 -3.33067 -1892 4 38.5504 4.73291 16.7401 -7.14778 -2.92142 -9.36231 -1893 6 21.0846 9.20759 23.9691 5.60032 -0.18462 4.18544 -1894 4 20.9445 8.65571 23.1711 -3.69603 16.8592 7.46004 -1895 4 20.5672 10.0363 23.9442 1.93643 -14.5945 -11.3561 -1896 6 6.46938 36.1391 20.0069 4.0004 4.10087 4.13062 -1897 4 5.99357 35.3124 19.8297 -2.3473 7.0562 -2.30419 -1898 4 7.3052 35.893 20.4098 -0.600933 -5.92452 -3.30983 -1899 6 17.7588 23.4635 11.2444 16.528 -28.2646 53.7307 -1900 4 16.9432 23.8548 11.0264 -32.805 26.4079 -23.7501 -1901 4 17.621 23.3206 12.2167 9.32529 -0.814156 -28.2078 -1902 6 2.23938 39.2705 23.5372 32.4488 -19.3396 -21.3039 -1903 4 2.96143 39.1072 24.212 -19.8533 -4.03587 -26.9428 -1904 4 2.57592 39.0525 22.6024 -11.4643 11.6849 46.2914 -1905 6 21.7189 10.3135 3.08585 -2.90529 19.7604 61.578 -1906 4 21.843 10.1221 2.19424 -0.974385 -17.6276 -55.1642 -1907 4 20.7734 10.4085 3.28686 2.80557 -4.86174 -11.6796 -1908 6 13.3371 37.6485 26.8148 34.7445 -2.08205 -3.58175 -1909 4 12.7942 37.01 27.2655 -5.666 -15.7112 8.11946 -1910 4 14.1995 37.1812 26.5945 -31.1056 12.6209 6.4215 -1911 6 45.679 9.86525 8.82671 -1.22844 -5.97168 -0.0165319 -1912 4 45.3204 9.57969 7.98479 1.29945 7.51218 -9.52666 -1913 4 45.2548 9.27624 9.44517 -6.37871 -3.09075 9.62419 -1914 6 39.8117 32.343 29.5858 -3.04799 14.0722 -9.88422 -1915 4 39.6223 31.4471 29.2796 3.58631 -7.81261 7.71305 -1916 4 40.3439 32.3214 30.3816 0.770365 -10.1242 2.16071 -1917 6 39.1301 32.1592 8.96473 45.9624 -7.76569 -23.2306 -1918 4 39.6852 32.0596 8.1252 -31.4186 4.60772 35.1501 -1919 4 38.2007 32.2042 8.75798 -9.66602 0.778467 -8.76952 -1920 6 29.7501 11.3103 40.3404 42.6438 -12.6008 -10.1865 -1921 4 29.0692 10.6634 40.5326 -1.99158 -8.72077 -0.363163 -1922 4 30.6164 10.7842 40.3158 -34.6338 15.486 -0.0451708 -1923 6 24.8345 19.8801 29.8412 -7.59088 37.7695 16.0848 -1924 4 24.9026 19.0378 30.268 -1.65451 -21.4471 9.48031 -1925 4 24.5694 20.5293 30.547 8.64688 -23.6335 -15.2845 -1926 6 50.0799 29.4689 2.86832 11.3398 7.37373 -14.0975 -1927 4 50.7937 29.3382 3.51213 -5.95266 6.62042 -8.33887 -1928 4 50.5172 29.4209 1.98721 -16.9062 -3.16045 21.5768 -1929 6 26.3158 13.2487 37.9516 44.6834 6.62304 1.7852 -1930 4 27.2667 13.2121 37.7291 -19.4356 -10.4808 -19.3263 -1931 4 26.4654 13.336 38.8817 -25.2145 10.5198 25.1195 -1932 6 24.3285 13.817 16.1492 -2.87417 -29.0242 -9.8062 -1933 4 24.8278 14.0306 16.9324 2.95884 13.8503 11.1204 -1934 4 24.1796 14.5912 15.6032 1.91347 13.6823 2.96602 -1935 6 21.9624 25.0824 8.00452 15.4008 12.078 14.6814 -1936 4 22.598 25.7039 7.58094 -6.50256 -15.9793 3.04336 -1937 4 22.4506 24.6482 8.74092 -7.92214 9.81208 -17.5113 -1938 6 50.1646 25.295 29.0323 7.20414 -13.325 -13.2678 -1939 4 50.9752 25.188 28.522 -3.46618 -9.57224 -11.582 -1940 4 50.4808 25.9292 29.6536 -4.58067 20.151 23.6328 -1941 6 23.186 6.81871 7.63171 8.52809 43.4321 -4.70249 -1942 4 24.005 7.36604 7.81791 -26.2659 -19.6382 -4.15731 -1943 4 22.4749 7.49932 7.50679 12.9101 -23.886 0.0924589 -1944 6 6.93738 5.85096 20.8328 -1.25739 23.0019 -5.42089 -1945 4 7.49016 6.65136 20.6793 -8.05782 -22.0664 2.33926 -1946 4 6.43567 5.73489 20.0135 6.68134 -11.6114 -0.0369962 -1947 6 25.4027 39.7503 23.9523 -6.31967 32.2782 -31.5462 -1948 4 25.6215 38.8259 24.0292 3.86532 -10.8289 -5.32001 -1949 4 25.5293 40.0494 22.9984 1.78505 -20.5244 33.6821 -1950 6 10.8465 30.682 2.12076 -14.9417 -4.95607 29.3443 -1951 4 9.91334 30.8811 2.27771 3.65307 -4.25506 9.47201 -1952 4 11.0492 31.2188 1.38489 10.4343 12.2811 -36.8692 -1953 6 23.0846 40.5263 40.0577 -14.1833 12.856 -13.2149 -1954 4 23.7732 40.7716 39.4116 -4.4893 -4.99974 3.24897 -1955 4 22.2685 41.0049 39.7737 14.5189 -12.3092 -2.05606 -1956 6 29.2062 28.3669 37.5673 -46.9973 46.4688 -26.4511 -1957 4 28.2092 28.447 37.3765 47.4284 -5.55714 9.99444 -1958 4 29.3363 27.5265 37.9547 9.31284 -31.0764 15.334 -1959 6 1.86163 12.1711 18.0765 -5.91003 5.49035 -5.71632 -1960 4 2.55659 11.9166 18.6527 25.6221 -14.4574 8.12849 -1961 4 1.26079 12.5379 18.7153 -20.6967 6.08864 -3.03965 -1962 6 35.8475 14.1052 8.57203 -21.6385 -0.893463 -33.3774 -1963 4 35.1968 13.4152 8.63145 -9.00219 -13.9675 31.2536 -1964 4 35.5915 14.3843 7.67264 23.8052 12.2531 2.11843 -1965 6 9.47935 39.8135 37.5891 59.0759 6.31763 -30.1219 -1966 4 10.4266 39.6693 37.2666 -35.8633 -8.68454 26.4626 -1967 4 9.26489 40.5592 37.0217 -20.4655 -4.29881 5.22341 -1968 6 3.55142 30.3339 19.2713 -4.86381 -1.52132 15.3498 -1969 4 4.33638 30.9045 19.2209 2.57405 -7.87202 3.73908 -1970 4 3.61239 29.7873 20.0935 6.99099 14.0083 -17.3235 -1971 6 36.3358 32.3745 17.56 -88.747 -21.2483 -18.3477 -1972 4 37.1123 32.7301 17.855 71.5568 29.0637 22.2427 -1973 4 36.4955 31.7908 16.8209 7.92507 -6.87638 -5.35096 -1974 6 22.0663 24.5107 41.4102 10.2987 16.3962 12.7497 -1975 4 21.8202 25.2352 0.099599 7.35269 -2.74787 -1.24985 -1976 4 21.4331 24.5495 40.7007 -15.7672 -0.145359 -12.6123 -1977 6 45.7559 15.6146 11.6534 9.54961 -0.52573 -11.8143 -1978 4 46.6616 15.9476 11.7359 -2.85604 3.39399 3.95489 -1979 4 45.8337 14.6574 11.6049 5.18085 -12.4794 -2.56515 -1980 6 22.3677 20.3608 16.0248 -8.43349 0.762232 -3.33301 -1981 4 21.8453 20.4382 16.8206 -16.1556 -9.64869 10.2413 -1982 4 23.0114 21.0388 16.1556 20.3116 20.3082 3.24798 -1983 6 25.8272 25.7408 18.9039 -4.38174 23.1082 -8.64826 -1984 4 25.2526 26.4897 18.6396 10.1677 -11.9346 2.39614 -1985 4 25.327 25.3554 19.6213 -1.60311 -10.6753 3.35926 -1986 6 35.3217 34.2027 33.2895 -15.2368 -41.9721 4.95923 -1987 4 35.4982 35.1152 33.2737 3.10328 43.0158 -1.14622 -1988 4 34.4946 34.1251 33.8 0.780353 -3.85018 -10.6306 -1989 6 39.2773 17.1161 17.3873 -13.1248 -32.2738 -8.05101 -1990 4 39.9918 17.6798 17.5739 28.094 23.6652 8.23643 -1991 4 38.688 17.6273 16.829 -11.1713 3.07886 5.75329 -1992 6 0.390078 14.9382 21.7871 11.1367 4.76555 -0.935352 -1993 4 54.4387 14.8735 21.5807 -4.47162 2.48431 -1.07762 -1994 4 0.539841 14.2564 22.4568 -0.558284 -6.24417 -4.29591 -1995 6 15.9777 23.2264 17.7728 8.65625 13.1041 -6.34263 -1996 4 15.4566 22.9884 16.9791 5.52796 1.00784 5.82867 -1997 4 16.2806 24.159 17.6616 -10.6082 -13.1932 5.11686 -1998 6 5.23931 11.1231 17.5575 35.8701 -10.5445 17.9772 -1999 4 4.9182 10.2425 17.6538 -30.0926 -10.858 -8.95801 -2000 4 6.0864 10.9521 18.0214 -7.64643 27.0942 -5.06777 -2001 6 9.32885 36.7248 13.2722 18.9931 -22.2768 -8.23823 -2002 4 9.60165 35.7781 13.2295 -3.69965 14.6724 -0.704445 -2003 4 9.76236 37.1699 12.5317 -7.58045 -2.70049 0.515103 -2004 6 25.4778 33.5648 0.584885 -10.5355 67.2754 -12.4068 -2005 4 25.5984 34.5208 0.879361 -11.6997 -30.6233 -9.64051 -2006 4 26.086 33.1118 1.1181 20.4991 -31.2317 29.3626 -2007 6 17.3118 24.383 31.3319 -1.28664 6.54307 -2.76395 -2008 4 17.7194 25.1777 30.9449 -5.40799 -4.17061 0.343513 -2009 4 16.6541 24.6578 31.9842 -4.89885 3.77294 -0.581941 -2010 6 50.5608 32.7082 27.7934 4.54158 -2.94952 -18.7634 -2011 4 50.7453 32.9177 28.6973 0.494052 11.2961 18.8161 -2012 4 49.6536 32.9735 27.676 -15.0266 -0.0998574 -2.84245 -2013 6 2.26734 37.236 16.1173 -6.42813 -12.7591 -21.9136 -2014 4 3.23226 37.3187 16.1136 -7.03488 -2.64717 4.42174 -2015 4 1.90002 37.4962 16.9584 8.86323 8.39289 12.7736 -2016 6 25.781 33.1953 8.40059 -29.5389 -21.3471 9.61313 -2017 4 24.912 33.1588 8.86731 13.6407 4.32372 -10.5279 -2018 4 25.7521 32.4014 7.84509 3.14784 4.30114 -1.53431 -2019 6 24.7803 7.83271 25.42 33.5144 32.018 13.9598 -2020 4 25.5535 8.29724 25.0002 -28.4293 -10.6828 16.5011 -2021 4 24.3491 7.42211 24.7041 -24.9556 -17.4551 -27.4815 -2022 6 44.0168 27.3303 21.5604 -2.1935 -26.0293 -25.9567 -2023 4 43.1804 27.7287 21.7105 -15.5436 25.6402 11.6584 -2024 4 43.7182 26.5374 21.0766 16.4483 6.01939 6.04345 -2025 6 20.8314 32.075 6.72772 34.1297 -23.9008 -4.85338 -2026 4 21.613 31.4679 6.7544 -19.7741 14.5872 -14.4381 -2027 4 20.6476 32.1788 7.6576 -7.69651 14.1485 11.3249 -2028 6 0.619789 26.0994 3.99415 -10.3518 14.1264 10.767 -2029 4 0.887335 25.4928 3.30986 5.36048 -13.1936 -7.97543 -2030 4 1.24971 25.9998 4.71308 0.85353 -1.82089 -1.56654 -2031 6 23.69 0.227417 22.8544 35.0871 1.11343 17.3571 -2032 4 23.3906 1.11513 23.0752 -8.28129 -2.57498 -6.74336 -2033 4 24.6181 0.214091 23.2237 -29.0994 -2.98435 -11.3486 -2034 6 35.6339 26.9438 6.46453 10.8918 50.3879 3.14258 -2035 4 36.2586 27.0344 7.19591 -3.09793 -24.7425 -0.485193 -2036 4 35.6905 27.8753 6.10871 -13.1004 -35.3011 6.52721 -2037 6 50.1792 7.09321 18.6927 -10.3798 0.485236 0.91939 -2038 4 50.7755 7.39768 17.9917 2.23399 -7.26744 -1.07457 -2039 4 49.6856 7.89728 18.8977 2.66313 1.30029 -2.34319 -2040 6 12.4725 14.8259 12.1994 -11.4238 -12.6169 14.8051 -2041 4 11.6664 14.488 12.6556 18.5487 5.78377 -7.93059 -2042 4 12.1518 15.362 11.4889 -6.75978 6.85562 -13.2996 -2043 6 52.4644 22.357 36.3266 1.29806 9.96622 10.4358 -2044 4 51.6029 21.898 36.3064 11.3287 0.910024 -15.7837 -2045 4 53.0734 22.0059 35.6434 -17.6122 -2.36697 5.80151 -2046 6 41.7741 11.4843 39.1248 -4.39753 -8.31887 -97.8346 -2047 4 42.1028 11.6824 39.9378 27.3537 17.7413 77.2645 -2048 4 42.4804 11.7867 38.4877 -22.5072 -9.73773 16.9601 -2049 6 13.8016 22.5118 39.1095 -61.9889 -17.7515 -30.6487 -2050 4 12.8197 22.2903 39.2632 45.6803 12.2331 1.0283 -2051 4 13.898 22.318 38.1378 10.5436 5.15112 27.5343 -2052 6 28.757 19.5278 21.8422 22.1809 -34.574 6.30338 -2053 4 29.5381 18.8977 21.7155 -30.335 22.4331 6.48321 -2054 4 28.5907 19.9346 20.9925 4.65837 4.37905 -10.6157 -2055 6 8.3499 21.6369 36.3971 -4.18721 -6.14707 -6.4426 -2056 4 8.67403 22.5346 36.3601 -3.60933 11.4321 4.1017 -2057 4 7.70004 21.5677 37.1222 1.54916 7.87236 -6.53046 -2058 6 39.9526 23.9745 15.2115 13.6309 -13.3423 -31.903 -2059 4 40.8439 23.5703 15.3899 -24.3155 14.8143 -11.3375 -2060 4 39.7878 23.9253 14.2154 4.70535 3.62281 36.021 -2061 6 8.1527 38.6897 22.5283 9.69445 13.3876 41.2978 -2062 4 7.76273 39.4363 22.0797 -11.7526 5.15604 -12.9046 -2063 4 8.4358 39.1168 23.3873 -5.25998 -17.8667 -18.7912 -2064 6 10.8496 20.1728 28.9641 16.4592 -1.26099 15.6701 -2065 4 9.98954 19.7606 29.0198 -7.88942 -4.93169 1.40711 -2066 4 10.9743 20.477 28.0788 -3.54014 6.836 -18.3013 -2067 6 36.8958 23.8215 41.8184 -11.2791 50.4956 -15.8947 -2068 4 37.6092 23.2626 0.106032 31.5333 -36.7229 14.8491 -2069 4 36.0533 23.398 41.8576 -15.1401 -19.7994 6.87638 -2070 6 23.7844 40.6753 33.3645 25.4398 -8.90266 -26.6636 -2071 4 23.0047 40.9559 33.8219 -17.4738 3.31201 10.6553 -2072 4 23.8864 39.707 33.5122 -4.88896 17.7845 5.86364 -2073 6 4.67086 19.2968 35.4027 23.2175 14.2952 24.1117 -2074 4 5.52557 19.1329 35.8895 -25.1286 -0.194605 -14.6261 -2075 4 4.47498 18.5363 34.8535 5.06934 -11.7578 -4.1199 -2076 6 9.45318 25.7818 10.8943 -12.0967 -8.54473 -2.48434 -2077 4 9.17249 24.8577 10.8042 5.18757 -1.88658 7.00696 -2078 4 8.69489 26.2739 10.5541 4.04726 3.8113 4.64502 -2079 6 27.2856 22.4903 13.6084 -4.27813 -9.26261 -11.4963 -2080 4 27.1477 21.7546 14.2243 0.799228 0.372191 -1.31996 -2081 4 27.4324 22.0688 12.7356 2.14896 10.5831 15.5277 -2082 6 41.0369 18.7679 23.2817 21.3973 -17.1333 -11.6606 -2083 4 40.4805 18.1775 22.7581 -1.93352 7.79722 7.02989 -2084 4 40.5302 19.4817 23.6332 -16.07 12.1618 6.58845 -2085 6 46.4867 28.3511 20.139 19.5633 -2.73425 79.1757 -2086 4 45.7489 28.0125 20.7058 1.11057 9.83041 -23.9354 -2087 4 47.2126 28.3766 20.859 -22.6454 6.05643 -47.0217 -2088 6 14.8422 15.3983 30.0672 9.57922 -13.7488 21.5316 -2089 4 14.7114 15.4303 29.1407 -5.18406 2.12307 -31.6519 -2090 4 14.4223 14.5569 30.327 1.67929 11.6926 7.32181 -2091 6 23.5155 24.7614 35.2027 10.8097 10.1661 11.7756 -2092 4 22.8249 25.3921 35.4883 8.74662 -8.07224 -2.50931 -2093 4 24.264 24.8574 35.8273 -14.1502 1.20627 0.95778 -2094 6 19.9045 24.2066 28.4368 -7.08314 38.6572 -15.5481 -2095 4 20.1199 25.09 27.9887 -7.53461 -31.417 18.3002 -2096 4 18.948 24.2479 28.615 8.77669 -1.27719 -1.90381 -2097 6 45.9703 7.63062 20.2339 -9.12647 -14.8446 45.7383 -2098 4 46.0314 7.87281 21.2057 4.66889 -10.1155 -32.2433 -2099 4 46.2124 8.39508 19.7344 6.23892 21.3693 -9.48098 -2100 6 38.0366 12.4686 8.28298 -82.8488 23.4696 -21.0017 -2101 4 37.3097 13.1608 8.47894 48.7672 -25.4087 1.47773 -2102 4 37.4891 11.9231 7.63396 42.6716 2.94367 19.7224 -2103 6 46.9352 18.181 8.45984 -29.3266 9.95329 16.0714 -2104 4 46.1825 17.5598 8.49993 9.84889 1.25457 2.04897 -2105 4 47.3911 17.9594 7.65971 14.7535 -7.6497 -21.4463 -2106 6 10.8592 13.9727 9.37152 -3.14543 -2.30259 -2.26695 -2107 4 10.3309 14.6626 8.91794 11.6563 -8.1882 2.6931 -2108 4 11.7607 13.9013 8.99546 -12.5287 13.781 2.06755 -2109 6 34.3902 5.43491 14.0826 12.6346 -17.837 -1.14204 -2110 4 35.1666 5.80709 13.6695 9.45544 21.1547 -1.41353 -2111 4 34.3397 4.58795 13.6148 -10.7305 -5.41844 9.88093 -2112 6 0.19016 0.223418 22.9526 3.77382 -24.7853 -3.01602 -2113 4 0.21308 41.6498 22.1069 2.59646 7.80057 12.2766 -2114 4 54.882 1.08863 22.7473 -12.4607 27.7599 -7.08256 -2115 6 40.9349 30.5562 37.8906 -27.573 -19.5948 34.9696 -2116 4 40.0494 30.8463 38.2359 23.4276 0.414778 -20.0189 -2117 4 41.1198 29.7844 38.4793 13.2677 19.1991 -19.1849 -2118 6 16.6358 17.3088 12.6818 26.7235 26.3695 -9.20965 -2119 4 16.2617 16.4703 12.4231 -8.92935 -8.7699 -0.695474 -2120 4 17.0088 17.6771 11.8494 -7.35458 -7.68048 15.4997 -2121 6 29.681 5.43286 24.7605 9.99716 1.48249 -7.0405 -2122 4 30.3348 5.91815 24.2382 -0.696307 0.629534 -2.6419 -2123 4 30.0075 5.55596 25.6632 -4.07672 -1.78023 1.29455 -2124 6 49.8902 0.287541 27.2058 21.9743 -13.7053 4.20571 -2125 4 49.8511 0.519591 26.2742 -5.37584 5.48457 -4.26768 -2126 4 50.7946 41.8257 27.2858 -12.157 4.98657 1.57708 -2127 6 31.2412 31.7366 15.2127 13.4193 29.9729 -4.01619 -2128 4 31.644 30.8863 15.3566 3.05611 -13.2507 6.82249 -2129 4 31.9953 32.37 15.1128 -22.0385 -12.9049 3.52444 -2130 6 35.7903 24.1511 16.9464 13.6459 1.10276 -6.74723 -2131 4 35.6731 24.9832 16.4455 1.01595 -13.8109 1.97492 -2132 4 36.7089 23.8312 16.7527 -22.9866 2.97508 8.81266 -2133 6 24.2751 4.63968 36.7374 -16.5997 -22.3051 -33.4925 -2134 4 24.7608 5.22686 37.2962 14.6544 10.0168 10.4919 -2135 4 24.7016 4.68474 35.8573 -7.94113 -0.389021 16.9181 -2136 6 17.5636 12.9031 3.65869 27.6744 1.86844 -28.0383 -2137 4 17.6858 13.5605 2.94059 1.9993 -16.4932 11.4828 -2138 4 16.8984 13.3068 4.18363 -27.8054 1.98581 18.3397 -2139 6 4.17446 14.2934 18.2709 12.2351 -24.5699 -15.5283 -2140 4 4.25201 13.3082 18.1842 -5.45348 23.7329 4.34334 -2141 4 3.28482 14.5076 18.5604 -13.4286 -3.54266 5.37394 -2142 6 19.1793 36.8557 22.3908 -6.26797 4.12828 -2.16449 -2143 4 18.7803 36.3059 23.064 -4.74301 -7.71326 18.3965 -2144 4 19.5341 36.2254 21.7686 7.87239 -11.0625 -9.31555 -2145 6 15.659 11.9578 13.1999 9.98626 24.0921 3.91449 -2146 4 15.6233 12.8387 12.7526 3.08695 -23.3335 12.0049 -2147 4 16.532 11.8904 13.6603 -13.5492 -1.68197 -15.0215 -2148 6 24.7583 21.9129 5.36621 -52.0449 4.43235 28.4012 -2149 4 24.9756 21.6947 6.28233 10.5491 3.37037 -1.58044 -2150 4 23.7611 21.9216 5.43181 35.5612 -5.35731 -13.8865 -2151 6 52.741 18.5708 35.2268 19.1809 2.02674 5.12186 -2152 4 52.5591 18.101 34.4104 -23.468 -7.47943 -3.72799 -2153 4 51.9957 18.6447 35.8177 -20.5936 -5.49273 0.0575333 -2154 6 3.56038 27.2788 25.2921 -16.6903 -17.6792 -11.4043 -2155 4 3.96469 27.2185 26.149 7.10467 -3.13705 18.347 -2156 4 3.97939 27.9962 24.8424 10.8751 21.6711 -8.62461 -2157 6 34.4448 32.9974 30.68 48.2331 9.00339 -1.41906 -2158 4 33.5189 32.8245 30.8394 -9.09046 9.48004 8.12592 -2159 4 34.8804 33.6211 31.3233 -29.3839 -17.782 -5.29467 -2160 6 35.2611 23.7526 9.83248 5.28039 9.63542 14.9856 -2161 4 34.4624 23.9143 9.32096 3.45609 1.41047 -6.97204 -2162 4 35.624 22.9154 9.5528 3.26088 -11.8232 -8.34585 -2163 6 42.4243 15.7233 8.97763 12.8326 1.39623 12.6931 -2164 4 41.658 15.328 8.60072 -22.8346 -8.994 -22.1277 -2165 4 42.104 15.9534 9.85586 1.77226 3.68974 5.84069 -2166 6 7.76866 28.8533 32.9548 -11.0049 17.2013 -15.4709 -2167 4 8.04862 28.1203 33.4848 1.42969 -15.0059 16.0601 -2168 4 8.50079 29.0495 32.3677 8.58058 4.20069 -3.59376 -2169 6 17.6953 41.2515 36.4663 -11.3067 -18.3758 74.5383 -2170 4 16.8889 41.7296 36.6796 -1.19906 6.43806 -6.60961 -2171 4 17.8689 41.3412 35.574 12.2332 11.1792 -57.8962 -2172 6 28.5157 24.2416 15.5518 -29.4686 -13.3801 -11.1317 -2173 4 29.0166 24.9984 15.2559 10.2779 3.66755 -9.57255 -2174 4 28.1226 23.7858 14.7645 18.214 7.11075 11.8426 -2175 6 20.955 16.2999 1.15679 52.4547 14.172 -5.31351 -2176 4 20.9215 15.3848 1.33551 1.21723 -32.5558 11.4722 -2177 4 20.0795 16.5686 1.08505 -57.8144 13.7968 -3.85053 -2178 6 31.1684 40.7359 5.3086 9.60886 -48.7905 -14.3252 -2179 4 30.3201 40.4364 4.96776 -1.1434 5.1051 1.34806 -2180 4 31.1111 41.6485 5.46945 -11.8258 44.905 11.395 -2181 6 29.926 24.7744 36.4585 -3.76808 18.8348 4.26027 -2182 4 30.4252 25.4661 35.9713 -7.21832 -13.6313 5.02454 -2183 4 29.9738 23.9763 35.9568 8.68635 -20.1437 -13.5665 -2184 6 8.66863 31.0429 3.90108 5.49181 -25.3701 -11.391 -2185 4 7.74616 30.7992 3.95988 -7.56137 -0.630176 -1.16432 -2186 4 8.75287 31.8877 4.30735 2.25384 31.6916 10.4967 -2187 6 5.52708 32.7014 11.4113 -17.1068 -29.6258 4.38787 -2188 4 4.72561 33.1583 11.715 12.8879 6.23598 -5.09299 -2189 4 5.16474 31.7796 11.3163 19.6841 23.1791 1.24929 -2190 6 45.6525 35.4522 20.4433 4.50188 -15.2767 -13.8779 -2191 4 45.1533 35.403 19.6071 0.884587 3.9764 11.125 -2192 4 46.1815 34.6145 20.4501 -8.61117 18.3435 2.22997 -2193 6 19.5135 2.78077 9.78076 -23.679 -24.2198 -16.6656 -2194 4 19.3296 3.70289 9.60293 -7.62346 7.89228 3.64078 -2195 4 18.7563 2.26696 9.35595 24.4568 20.2801 14.4664 -2196 6 54.9521 9.08257 10.915 1.41457 -13.8994 3.08946 -2197 4 54.8451 8.89609 11.8656 1.69601 3.75098 -5.72792 -2198 4 0.659909 9.73404 10.7859 1.63405 2.05096 5.26063 -2199 6 21.028 26.5613 14.7909 22.3934 -16.1712 -61.6784 -2200 4 21.2545 26.1082 13.8887 -5.63248 33.4215 43.8962 -2201 4 20.0757 26.5096 14.8457 -4.66041 -4.09977 8.40724 -2202 6 14.1565 30.5187 27.5481 43.0568 3.88252 13.2649 -2203 4 14.5478 30.2647 28.4319 -11.7888 3.54471 -30.6513 -2204 4 14.9443 30.8429 27.0102 -33.9181 -6.53128 14.6047 -2205 6 29.8147 17.3367 31.0866 -27.8518 -4.92818 12.2149 -2206 4 30.6554 17.4646 30.6741 20.9401 8.7355 -10.9161 -2207 4 29.248 18.1063 30.9142 12.1966 -0.59561 3.44929 -2208 6 50.8794 17.2985 27.8251 -38.7154 2.44379 -6.74856 -2209 4 49.927 17.6315 27.8951 41.9068 -8.6615 -2.42711 -2210 4 51.4551 17.8493 28.3603 -3.47276 2.02156 5.1771 -2211 6 46.2645 37.0852 13.9854 4.42941 -15.3994 -45.1385 -2212 4 46.1048 37.4162 14.8449 -7.65894 23.339 32.9902 -2213 4 45.682 37.569 13.3645 -0.578519 -6.08013 10.2779 -2214 6 38.1859 37.2676 33.1408 3.52211 -11.0724 24.5555 -2215 4 38.5393 37.4103 34.0404 -6.68303 -10.0954 -6.88307 -2216 4 38.6219 37.9461 32.6369 2.42637 17.4604 -15.0111 -2217 6 41.8357 13.3473 31.1178 -16.0625 23.8584 17.742 -2218 4 41.5851 13.9423 31.8754 7.82637 -22.3228 -20.2899 -2219 4 42.4009 12.6411 31.4368 6.59024 -10.1979 3.85371 -2220 6 46.9027 12.6459 17.8387 -27.1897 30.7666 -32.0186 -2221 4 46.619 13.5972 17.8049 11.7948 -22.8605 3.48595 -2222 4 46.5208 12.2901 16.9886 18.0608 -3.03081 22.7278 -2223 6 32.0582 10.0955 10.6527 -31.4378 50.3229 23.4622 -2224 4 31.7762 9.76632 11.5317 8.81554 -8.40176 -19.9459 -2225 4 31.6698 11.0464 10.7004 29.7372 -48.0302 -12.3835 -2226 6 34.0062 11.3773 6.75186 17.7871 30.589 25.6979 -2227 4 33.4869 10.5999 6.69262 -19.6684 -30.9606 -3.70709 -2228 4 33.8274 11.7035 7.66069 0.227829 -0.558148 -16.2574 -2229 6 45.3288 30.8634 19.4834 2.25993 -0.395596 -7.26595 -2230 4 45.2654 30.706 20.4282 2.85912 -9.1252 8.63447 -2231 4 45.808 30.1003 19.1195 -1.86475 4.39364 7.74954 -2232 6 20.3535 0.575918 7.15275 2.53913 19.7072 2.1264 -2233 4 20.3036 0.62077 8.11765 -6.02971 -5.31178 -3.74759 -2234 4 20.3373 41.5708 6.90351 -3.42232 -20.4047 0.354773 -2235 6 15.9901 39.4523 4.14302 -22.6863 14.3541 -4.96379 -2236 4 15.4898 39.956 3.48033 13.9059 -6.08345 -3.0001 -2237 4 15.6535 39.8695 4.95456 5.06581 -11.7067 3.21286 -2238 6 52.4222 16.4823 25.1021 7.38571 -14.026 0.748627 -2239 4 51.9391 16.8928 25.8315 -3.23714 5.96419 -6.435 -2240 4 52.4547 17.0876 24.3371 -9.72126 -3.91711 12.1205 -2241 6 38.5305 12.9945 3.24722 36.6577 77.8042 9.91619 -2242 4 38.7269 13.7231 3.96388 -16.2716 -45.5952 -32.5571 -2243 4 38.0745 12.2732 3.61889 -23.0516 -27.5087 18.4748 -2244 6 35.1404 29.6968 31.1683 -32.7778 -10.63 75.6098 -2245 4 35.326 30.1595 30.3922 19.5999 28.8984 -42.5223 -2246 4 34.769 30.3505 31.8393 8.36493 -22.8372 -28.4638 -2247 6 9.52941 33.7628 4.86075 -28.4918 10.8311 18.4951 -2248 4 9.24769 34.3211 5.62607 6.24621 -9.23174 -22.6788 -2249 4 10.3628 33.3905 5.10095 17.2263 -8.07265 -0.549435 -2250 6 21.5384 22.0668 20.5377 -8.24916 -13.7408 18.0665 -2251 4 20.8389 22.6833 20.2982 1.69112 5.82217 1.92954 -2252 4 21.3229 21.7148 21.445 5.44386 11.4228 -26.5573 -2253 6 37.5752 11.1922 41.2961 -25.7405 -15.8592 15.4541 -2254 4 38.0284 11.8044 40.7564 10.4246 30.4728 -30.151 -2255 4 38.2644 10.586 41.5433 15.0535 -11.8566 15.4014 -2256 6 33.8981 1.42806 38.7459 -9.94409 -6.93964 -8.18458 -2257 4 33.592 0.608166 38.3248 2.39341 2.703 9.2739 -2258 4 33.9534 1.28552 39.7002 -3.4763 3.29487 -4.45631 -2259 6 4.57081 26.6822 28.0049 6.08842 -57.033 -35.5124 -2260 4 5.0914 25.8197 28.0746 -15.9746 40.4578 4.78317 -2261 4 4.85783 27.3427 28.6052 16.6445 16.915 24.1865 -2262 6 10.2586 0.903759 11.6235 -14.777 -30.5961 35.2813 -2263 4 10.598 1.12099 12.5147 -1.53351 -1.03605 -18.7158 -2264 4 10.5217 1.55247 11.0069 12.731 34.1315 -22.4253 -2265 6 17.6428 19.8087 2.34625 28.3489 11.7442 10.4095 -2266 4 17.8694 20.4455 1.65312 -0.920106 -2.92675 2.15413 -2267 4 18.5186 19.4679 2.66241 -18.7748 -2.39069 -7.57655 -2268 6 32.4269 25.6656 16.4745 -22.7384 46.4686 12.005 -2269 4 32.9526 26.0936 17.1754 -0.693509 -13.2017 -11.5041 -2270 4 32.8268 24.9018 16.1119 18.5502 -33.1172 -3.66835 -2271 6 33.2526 10.6326 0.323883 9.44704 -29.8166 -9.67306 -2272 4 32.8511 9.97264 41.5994 12.5609 21.6724 15.7642 -2273 4 34.1113 10.2426 0.662313 -26.6835 12.0422 -7.05376 -2274 6 4.94395 4.51414 10.1428 13.8645 5.4827 29.102 -2275 4 4.09398 4.95549 10.181 -4.94694 -3.34603 -2.54834 -2276 4 5.29018 4.56097 11.0773 -8.61071 -3.77852 -28.7481 -2277 6 27.0981 16.9726 9.55361 -31.982 10.5528 -14.2027 -2278 4 27.1645 17.5497 10.32 4.78099 0.707575 6.97209 -2279 4 26.2221 17.2303 9.15822 25.9284 -7.90001 11.4222 -2280 6 9.97547 10.5192 19.3751 2.18725 8.20489 55.882 -2281 4 10.4385 9.92127 18.8097 14.3325 -20.7925 -15.5795 -2282 4 10.1136 10.195 20.3283 -2.00877 10.2565 -41.5362 -2283 6 19.5726 8.5313 27.8509 32.1681 -5.32712 19.6321 -2284 4 20.0623 8.73326 28.6965 -13.9453 -3.32017 -28.6613 -2285 4 20.1531 7.88958 27.3718 -16.7413 15.1406 10.2365 -2286 6 47.0715 38.9553 23.1297 -19.9487 1.16408 5.20576 -2287 4 47.6755 38.9992 22.3956 6.55525 -5.77104 -8.99339 -2288 4 46.1921 38.7934 22.7438 5.29072 4.97192 1.21114 -2289 6 19.6864 25.3648 11.2698 -35.9279 -4.62509 3.50742 -2290 4 18.9891 24.6498 11.3772 26.0807 25.4649 -7.71219 -2291 4 19.2193 26.1995 11.535 7.74761 -20.7647 -6.77192 -2292 6 27.3916 13.4622 15.7395 34.9583 -25.2468 -27.4167 -2293 4 26.6227 13.8144 16.1317 -23.8298 14.7279 29.1585 -2294 4 28.0863 13.1847 16.3728 -7.05347 8.15442 -0.924368 -2295 6 18.6718 14.1326 1.43279 -0.407031 -28.5308 -28.57 -2296 4 18.3771 15.0354 1.29678 -0.169849 11.7565 -8.38297 -2297 4 19.1904 13.8513 0.615983 -22.2167 19.1803 27.2908 -2298 6 42.3082 22.0346 32.4819 -45.1257 5.10199 -13.868 -2299 4 42.1064 21.5657 33.301 1.02444 -1.81924 7.74271 -2300 4 41.4227 22.4584 32.2639 35.231 -14.359 4.36271 -2301 6 10.0299 9.44853 2.50633 35.8335 -20.1603 -5.5533 -2302 4 9.22808 9.80314 2.87263 -22.9312 8.40439 12.9687 -2303 4 10.3707 8.71125 3.07205 -18.436 14.324 -8.13067 -2304 6 6.82989 1.45163 22.0085 -48.1074 -31.7833 -34.6048 -2305 4 5.93364 1.52189 21.5813 27.761 13.2569 19.2226 -2306 4 6.99793 0.508973 21.801 12.0554 14.7409 9.93393 -2307 6 11.2802 27.0298 18.9733 1.62982 48.8223 -5.8971 -2308 4 11.8533 27.1031 19.7597 -5.53045 -6.49976 -4.21856 -2309 4 11.2066 27.9871 18.6476 2.337 -33.8373 14.078 -2310 6 41.4807 20.5084 27.2133 -10.1157 30.3313 5.28758 -2311 4 41.6238 21.1535 27.9303 0.1153 -0.646751 -15.7402 -2312 4 41.3475 19.7242 27.7174 2.20222 -28.2193 4.24429 -2313 6 15.4457 24.115 33.4309 -8.0908 -15.9975 4.96928 -2314 4 14.6694 24.1264 34.0087 5.2648 16.329 -3.20307 -2315 4 15.6051 23.1634 33.3621 10.6851 2.75783 3.25666 -2316 6 36.1374 16.3773 10.0083 -2.95201 1.72364 21.0093 -2317 4 36.0354 15.4723 9.6971 0.275369 -1.57281 -6.84486 -2318 4 36.1532 16.3058 10.9756 2.3103 1.89663 -9.38056 -2319 6 51.7249 16.2592 2.09899 -0.8354 -35.479 4.00209 -2320 4 51.3025 16.6477 2.84061 -15.4293 29.383 24.1936 -2321 4 51.7588 15.3279 2.40044 5.70816 13.7616 -13.313 -2322 6 23.409 8.55726 39.7719 39.5062 -11.15 -25.6965 -2323 4 23.7264 8.82822 38.8637 -18.295 -2.70527 32.3134 -2324 4 24.154 8.00621 40.1033 -17.8621 14.2471 -2.43096 -2325 6 36.7611 34.4487 21.1056 -9.59584 -7.71653 -9.58874 -2326 4 37.1943 34.5847 20.2534 -2.45984 1.11901 0.357954 -2327 4 35.8017 34.351 20.9183 13.0848 5.20904 4.89404 -2328 6 14.146 8.88688 27.2949 11.3522 43.6232 -16.453 -2329 4 13.5534 8.17113 27.3093 -27.716 -37.4722 8.68734 -2330 4 15.0033 8.5993 27.5988 11.0136 -4.6565 4.44913 -2331 6 20.6652 37.4903 25.1946 -10.211 -17.9881 -36.0994 -2332 4 20.7454 36.6557 24.6643 4.11278 14.2078 23.4923 -2333 4 20.5382 38.1243 24.4693 3.50396 4.35638 18.4557 -2334 6 28.825 24.4792 30.0383 -7.87557 -12.5525 -14.3175 -2335 4 28.2203 24.3409 29.2957 -5.62902 14.2643 8.72595 -2336 4 29.6177 24.0933 29.6588 14.1928 -3.34691 9.72359 -2337 6 8.38024 12.0023 23.6849 17.6034 -17.8042 43.8798 -2338 4 9.33151 12.0391 24.0095 -25.5352 0.9508 -22.7134 -2339 4 7.93543 11.4413 24.3789 8.15752 13.9726 -18.9857 -2340 6 16.0957 26.6613 22.9482 -4.23776 -4.88874 3.00129 -2341 4 16.4041 25.8866 22.4682 2.11349 3.20317 -0.347462 -2342 4 15.2797 26.4088 23.4009 6.04671 4.79823 1.078 -2343 6 22.346 41.3881 9.48723 24.9275 -16.664 -2.62618 -2344 4 22.5706 0.299269 9.06271 5.87112 18.1013 -4.15908 -2345 4 21.5005 41.5154 9.87839 -30.5435 3.49176 4.55444 -2346 6 49.3776 19.1851 32.3736 41.1751 -38.6142 12.6649 -2347 4 49.9515 18.5305 32.8666 -19.8114 22.1793 -24.5398 -2348 4 48.9751 19.6643 33.0815 -18.7203 16.5505 12.5326 -2349 6 29.672 28.434 31.2292 -0.0990093 -59.7528 33.1636 -2350 4 30.5672 28.114 31.0525 8.33151 24.242 -15.2883 -2351 4 29.4026 27.6233 31.7702 -3.76231 36.9508 -17.5145 -2352 6 5.09757 39.1181 23.5694 28.9365 -16.8561 66.257 -2353 4 5.426 38.785 24.4883 -20.96 9.44698 -53.4069 -2354 4 5.17377 40.064 23.6953 -4.19226 13.7611 -6.16678 -2355 6 42.9396 13.594 41.6013 33.1291 -45.1938 12.1175 -2356 4 42.8466 14.3322 41.0449 -16.6361 37.6348 -21.2948 -2357 4 42.1546 13.3797 0.17078 -22.3633 5.8076 7.08965 -2358 6 21.2201 12.4318 7.37385 41.5974 -14.6934 -10.3279 -2359 4 20.2896 12.3563 7.35505 -36.2241 5.92132 -7.85999 -2360 4 21.5284 11.6004 6.96932 1.7608 11.2928 4.8084 -2361 6 43.1404 26.8989 37.6922 38.0431 -66.5876 34.8581 -2362 4 42.455 26.3454 37.3085 -15.3628 11.0452 -11.3741 -2363 4 43.7284 26.1839 38.1775 -25.099 52.0029 -25.4853 -2364 6 19.5406 10.6485 41.687 -7.00401 -34.9019 -10.1363 -2365 4 19.0738 10.6767 0.596923 -7.19888 -1.38148 21.2635 -2366 4 19.8536 11.5162 41.559 12.2515 43.5875 -9.13673 -2367 6 53.6223 10.061 3.2559 12.5469 7.56169 -12.6981 -2368 4 54.2024 10.8465 3.22155 -5.5124 -7.95383 7.8004 -2369 4 54.0687 9.40413 2.68363 -10.8512 12.6529 5.34221 -2370 6 17.5742 20.1926 28.4231 -27.2496 23.4973 23.4861 -2371 4 18.0413 19.6307 27.8376 17.787 -14.8025 -21.0857 -2372 4 18.1273 20.2938 29.2048 3.54631 -0.489564 0.0042962 -2373 6 36.884 7.32584 1.68504 -56.6071 21.2656 -14.3658 -2374 4 37.7051 7.59774 2.01592 38.2946 9.18211 20.2394 -2375 4 36.4748 8.1931 1.44071 3.42518 -20.8507 2.42249 -2376 6 29.2181 41.4159 1.83346 -7.01124 13.363 14.2223 -2377 4 28.4272 0.01466 2.15652 15.3791 -9.50345 -13.4545 -2378 4 29.1899 41.2946 0.880744 -4.61983 7.49126 -6.31737 -2379 6 13.5157 3.09172 8.12958 -12.3356 7.91728 -16.4605 -2380 4 12.824 3.78046 8.01164 12.4629 -9.10221 7.3254 -2381 4 13.8551 3.1491 9.02604 -1.1531 -1.24526 3.73064 -2382 6 15.0243 29.578 18.5071 -0.689822 5.1468 -1.91807 -2383 4 14.6889 28.924 17.8685 -1.8514 4.35612 11.642 -2384 4 14.2858 30.1508 18.7969 8.46412 -5.78667 -10.3485 -2385 6 10.5031 24.7013 24.3729 39.9308 52.3958 -21.489 -2386 4 10.8696 24.6855 23.439 -22.6214 -1.85919 30.3756 -2387 4 10.1444 23.8694 24.566 -23.1097 -44.7323 0.689524 -2388 6 2.33043 13.8499 25.1512 12.2217 -8.49201 10.1592 -2389 4 1.51988 13.5482 24.7402 -5.80441 -9.83551 -11.7005 -2390 4 2.2572 14.7938 25.1495 -10.3249 16.8303 -2.61333 -2391 6 31.8608 32.7615 29.8175 -5.917 1.92483 -13.0568 -2392 4 30.9148 32.9142 29.9093 1.86919 3.45723 4.06263 -2393 4 31.9038 31.8703 29.4643 1.33296 -6.10517 -4.90202 -2394 6 37.5413 40.8309 33.9785 -53.8639 -49.1526 -10.38 -2395 4 37.2515 40.0243 34.5353 23.0474 40.5808 -8.35317 -2396 4 36.818 40.8104 33.2846 24.4839 11.2763 19.2644 -2397 6 24.0486 38.1463 34.3459 4.38709 -25.8386 -29.9356 -2398 4 24.1932 38.0251 35.2675 1.20986 12.6476 31.9448 -2399 4 24.4562 37.3431 33.9843 -4.45208 9.66559 -5.62065 -2400 6 37.1813 22.5726 7.37313 12.7367 -26.0408 21.8779 -2401 4 37.6868 21.7363 7.50199 -14.9443 17.386 1.08188 -2402 4 37.2974 22.7741 6.46124 2.1827 3.60906 -24.8808 -2403 6 4.31908 23.2435 35.594 -25.7168 -2.52913 6.61784 -2404 4 4.31865 22.3787 35.1609 -1.33991 4.89576 -0.266123 -2405 4 3.37757 23.4898 35.7698 13.7393 -2.9658 -3.46645 -2406 6 15.7444 14.893 2.66063 14.3192 36.2435 46.5189 -2407 4 15.9445 15.8567 2.71494 4.00237 -25.0016 7.78932 -2408 4 15.3014 14.8369 1.84861 -12.1852 -13.1154 -36.1328 -2409 6 48.1607 23.1823 2.03014 17.998 -4.54201 -11.9107 -2410 4 48.5744 23.458 2.84259 8.43731 2.94545 12.5813 -2411 4 48.9225 22.9045 1.46682 -22.9697 5.41467 1.46601 -2412 6 24.1212 19.9771 21.5555 -13.5297 -6.85262 15.9953 -2413 4 24.2241 19.3198 22.2577 -12.7792 13.8262 1.69378 -2414 4 24.7627 19.6352 20.9706 23.452 2.79195 -33.2435 -2415 6 10.5793 29.3754 5.15175 -1.75103 26.9922 -14.4666 -2416 4 9.93004 29.8841 4.64694 -13.9608 -12.0643 5.47156 -2417 4 11.3599 29.8389 4.86113 16.4531 -5.21099 6.28998 -2418 6 5.96767 27.6933 31.2336 10.2296 -18.0279 -26.5205 -2419 4 6.63185 27.1353 30.7398 -17.0624 11.0978 13.8341 -2420 4 6.49058 28.2721 31.7915 6.44996 0.578865 12.7715 -2421 6 18.5397 25.8071 15.3312 30.8629 -17.2743 -78.9847 -2422 4 18.3277 25.7099 16.2038 -28.7942 6.39581 79.7195 -2423 4 17.897 26.3418 14.8644 -17.4943 11.9017 11.8989 -2424 6 52.0949 37.2335 11.1138 -0.736115 -25.1617 0.200807 -2425 4 52.5552 36.4743 10.7101 2.49656 11.0988 9.7325 -2426 4 52.7586 37.8745 11.3958 -2.29245 7.10647 -7.85035 -2427 6 46.8562 14.6296 7.3094 -39.0502 -6.9365 63.794 -2428 4 46.1382 15.0906 7.8718 34.2719 -4.68193 -40.7336 -2429 4 47.0431 13.9061 7.9424 14.2062 7.46383 -20.3992 -2430 6 22.2508 0.698906 41.6783 16.129 -5.34947 -25.8041 -2431 4 22.2008 1.66415 41.7125 4.72421 -6.65403 -6.59212 -2432 4 22.9559 0.389699 41.0229 -20.0941 20.4891 31.5318 -2433 6 4.05761 14.7345 9.27152 -10.7438 13.6286 -6.0443 -2434 4 3.56043 15.5915 9.15395 12.8436 -23.8424 -1.56379 -2435 4 4.93811 14.8828 8.92118 3.87558 5.66633 -1.10852 -2436 6 37.2917 12.6666 37.0157 -30.741 -16.0859 47.3668 -2437 4 37.7371 12.676 37.8973 0.89189 9.6387 -16.8975 -2438 4 36.3707 12.3712 37.2872 32.4569 8.65188 -22.8431 -2439 6 26.6682 29.0903 40.5985 -18.9168 16.4285 3.4146 -2440 4 27.032 28.2632 40.812 19.8197 -36.7417 16.2821 -2441 4 26.6469 29.0593 39.6552 2.37875 14.8387 -20.8034 -2442 6 7.22455 13.851 3.31845 32.6668 -55.3021 -17.7697 -2443 4 8.0198 14.2759 3.60088 8.05656 35.1068 9.02454 -2444 4 7.66854 12.9807 3.04146 -45.3946 28.1811 11.8363 -2445 6 8.95271 34.8627 28.8342 33.802 -52.1542 -15.9648 -2446 4 9.89817 35.0055 28.6074 -18.5208 0.484683 7.95646 -2447 4 8.56267 35.6958 28.9173 -17.8026 46.8286 13.0667 -2448 6 37.1756 40.0691 40.1061 46.0034 7.56439 6.60252 -2449 4 36.245 40.1688 40.0074 -20.2243 -4.13511 -1.70673 -2450 4 37.2907 39.5142 40.8911 -6.64471 -1.97244 -3.69085 -2451 6 30.3689 6.165 27.2364 16.9392 12.8422 63.3115 -2452 4 30.1126 5.75506 28.1249 0.00544273 9.78172 -37.0876 -2453 4 31.0397 6.83064 27.5702 -18.6179 -11.6186 -23.6342 -2454 6 10.4791 22.885 18.2972 2.22892 -25.7937 -34.5052 -2455 4 11.3494 23.0331 18.653 10.7715 4.73748 7.10061 -2456 4 10.6446 22.3032 17.5049 -10.188 21.0769 23.5682 -2457 6 35.8886 14.2524 40.1239 38.6938 29.9036 -1.43051 -2458 4 35.4161 14.6576 39.3846 -1.71718 -13.5804 13.4977 -2459 4 35.4021 13.6019 40.5864 -31.0402 -18.1501 6.5583 -2460 6 6.71723 1.08854 17.7001 -3.83901 -60.8198 25.71 -2461 4 6.23156 1.19942 18.5167 -3.21909 18.7445 0.671973 -2462 4 6.88149 0.099135 17.7878 0.895752 34.2898 -15.7018 -2463 6 41.3468 34.0461 33.1794 10.5682 19.0983 -18.7578 -2464 4 40.4721 34.2712 32.8864 -29.2649 -1.70533 3.43004 -2465 4 41.8357 34.5632 32.5195 11.425 -3.18121 9.05585 -2466 6 37.2595 0.990816 41.287 9.45411 17.3584 -9.40071 -2467 4 37.687 0.20533 40.9743 -1.4253 -22.058 -8.3634 -2468 4 37.4586 1.01742 0.30817 4.28067 1.92511 18.4856 -2469 6 25.2602 30.9527 6.20609 -41.9214 10.7977 -12.9978 -2470 4 25.877 31.4326 5.6764 28.9604 0.775163 -4.96937 -2471 4 24.4759 30.9469 5.60333 12.4846 -9.23957 25.2824 -2472 6 14.2056 24.502 28.3086 -25.5247 14.5131 -24.5719 -2473 4 14.1882 23.6623 28.7056 13.4522 -31.4953 30.087 -2474 4 13.7133 24.2842 27.5041 7.94148 19.2098 -3.82225 -2475 6 34.2051 26.2238 36.0112 -48.9031 41.3361 24.9979 -2476 4 35.1144 26.3624 36.1822 32.7561 -2.50775 4.45543 -2477 4 33.7446 26.9807 36.5344 19.2218 -36.9328 -23.3608 -2478 6 32.3568 8.33098 28 25.7802 40.2385 3.20277 -2479 4 32.7565 9.24505 28.063 -37.9579 -17.4528 3.85033 -2480 4 33.1461 7.94224 27.6538 8.5967 -27.8742 -9.28785 -2481 6 11.7867 0.286536 26.9724 -1.3913 -35.2382 4.72224 -2482 4 11.7865 41.2385 26.6946 0.846362 23.7064 4.93964 -2483 4 11.6054 0.272418 27.9282 2.03777 4.09428 -12.4872 -2484 6 1.68124 0.254113 10.3309 8.7986 -13.2184 -15.0921 -2485 4 1.59717 41.2916 10.7333 -0.0350141 -2.89412 -0.990995 -2486 4 1.41389 0.849687 11.0071 -7.7361 15.4014 20.6266 -2487 6 6.75173 13.8377 8.23874 -3.6693 30.6435 -30.4665 -2488 4 6.43924 13.9799 7.29904 9.51956 -14.6006 30.1073 -2489 4 7.1653 14.6974 8.43116 5.95594 -9.45057 4.81521 -2490 6 22.2348 20.5564 6.16471 -24.0844 -9.72934 13.195 -2491 4 21.6727 21.3518 6.25881 9.87637 -7.56006 0.262552 -2492 4 21.7029 19.8181 6.55593 11.5262 14.9976 -6.6436 -2493 6 17.385 20.4497 10.8769 -35.9329 27.9153 -37.8305 -2494 4 16.5515 20.156 10.4074 25.3596 -4.97581 21.0147 -2495 4 17.441 21.3848 10.5386 11.6957 -25.2138 21.3318 -2496 6 17.7006 4.52737 19.573 -11.3777 -34.9061 -6.08889 -2497 4 17.032 4.43128 20.2569 -5.49224 11.1956 3.68583 -2498 4 17.4813 3.72403 19.0236 15.4315 33.5846 4.92098 -2499 6 0.483339 18.1114 40.0861 11.4726 -7.5634 -25.4826 -2500 4 0.218803 18.6551 40.8031 -6.40406 19.3 17.6992 -2501 4 1.29471 18.4968 39.6981 -7.50073 -9.94226 4.45973 -2502 6 22.9439 24.8131 27.8304 -1.07592 37.7895 -56.3844 -2503 4 22.8309 25.5845 27.1671 -0.125595 -37.7338 24.1587 -2504 4 22.7938 25.2149 28.6606 -3.1997 14.6603 34.334 -2505 6 42.7926 39.1547 26.7662 4.75434 20.2168 6.00074 -2506 4 43.0175 38.5002 26.1242 -2.01943 -24.6309 -11.9253 -2507 4 43.3024 39.9142 26.4608 -1.73796 0.515913 11.2644 -2508 6 26.2338 3.05974 21.8008 -0.713756 21.3652 -6.58596 -2509 4 25.6341 3.75271 22.1513 17.432 -13.3686 -8.49125 -2510 4 26.841 3.50549 21.1637 -15.4189 -7.95734 10.2455 -2511 6 54.5913 9.88629 29.5891 14.6194 -0.200122 15.6168 -2512 4 54.0185 9.11016 29.6389 -2.18077 1.53735 0.0476299 -2513 4 54.8498 10.0557 30.5251 -12.748 -2.88746 -21.9109 -2514 6 24.7662 33.7505 20.5324 -4.4887 -11.5901 7.32024 -2515 4 24.6764 34.6709 20.8407 -1.82029 -5.26135 -2.53883 -2516 4 23.9322 33.4503 20.1388 -0.463927 12.2923 -3.35723 -2517 6 41.7034 16.3049 0.90063 -4.83399 22.4927 -47.1255 -2518 4 41.2734 15.9533 1.64089 -16.394 -13.425 40.883 -2519 4 42.6233 16.3659 1.12415 18.2298 -9.67465 4.77205 -2520 6 23.3998 27.9207 27.4832 -10.7606 37.0497 -28.3533 -2521 4 22.8282 28.3407 28.1441 5.00816 -9.79407 0.156118 -2522 4 23.2556 28.495 26.6632 8.58882 -24.5485 28.392 -2523 6 32.7859 37.2984 18.7364 25.7014 -40.2058 6.96479 -2524 4 33.7401 36.9719 18.7703 -32.5146 22.7172 4.70252 -2525 4 32.7784 38.1932 18.4283 6.4981 19.1078 -10.0488 -2526 6 21.2249 27.6889 4.78917 1.7584 -25.2435 -20.8654 -2527 4 20.596 27.4146 5.46499 -5.42949 1.48454 -4.75098 -2528 4 21.0369 27.1287 3.96943 -0.427807 22.4392 26.4825 -2529 6 54.9457 17.9605 1.83049 24.1732 12.1415 15.992 -2530 4 54.6765 17.1472 1.44643 -11.2843 -21.2768 -12.0273 -2531 4 54.1938 18.5428 1.86671 -18.1074 1.0363 -7.50679 -2532 6 36.7435 10.702 6.59289 -49.1612 2.30359 2.88264 -2533 4 35.7736 10.9925 6.66913 36.3355 -9.83622 -8.29906 -2534 4 36.7226 9.77144 6.87602 6.19961 4.27664 0.325158 -2535 6 54.2959 4.49421 14.021 -47.0247 26.1641 -8.2037 -2536 4 53.712 4.99768 13.3924 28.2438 -8.88077 8.93165 -2537 4 53.834 4.66365 14.8572 10.6634 -9.95324 4.36694 -2538 6 22.1071 12.8195 32.0067 31.7906 8.9597 -11.0311 -2539 4 21.2967 13.3066 31.9589 -27.922 0.108445 -0.906739 -2540 4 22.6887 13.2954 31.3728 -6.4895 -15.5456 16.1837 -2541 6 15.3021 36.6565 4.03444 -21.8215 23.8176 13.2077 -2542 4 15.3262 37.6185 3.88215 -1.10116 -7.72226 9.53853 -2543 4 16.0423 36.3695 3.52653 17.7184 -15.2462 -10.6327 -2544 6 23.951 1.27123 5.71091 12.3119 19.4094 13.4558 -2545 4 23.1735 0.716989 5.76524 -11.3354 -5.61231 -0.786433 -2546 4 24.0519 1.77027 6.55293 -6.00641 -12.6326 -15.7345 -2547 6 14.2792 12.648 15.8066 19.0644 9.13243 11.8341 -2548 4 14.5911 12.5731 14.893 -12.6174 -10.6299 -3.28453 -2549 4 13.3818 12.3002 15.9605 12.2346 2.97194 -15.7557 -2550 6 15.0388 40.2481 6.5891 -30.9219 -16.0267 -20.9978 -2551 4 15.8926 40.3583 6.97574 17.8619 16.6743 19.574 -2552 4 14.4622 41.0349 6.73493 18.0926 -11.8876 3.06612 -2553 6 48.5605 32.6308 12.0872 21.4935 -15.1737 -19.6402 -2554 4 48.2882 31.8163 11.6222 -11.7375 10.5522 8.8403 -2555 4 49.3772 32.8772 11.5869 -20.063 0.749688 13.0696 -2556 6 11.2909 31.5377 7.21713 -14.6129 -9.26005 -15.8818 -2557 4 10.6224 30.9548 6.78826 17.7824 9.96971 10.6082 -2558 4 11.6163 32.1134 6.50388 0.884245 -9.77636 6.63484 -2559 6 30.1231 27.9968 10.2226 9.10006 8.28679 -14.6513 -2560 4 30.718 28.7273 9.95045 -8.34799 -9.59518 10.9295 -2561 4 29.9727 27.4897 9.40845 -5.6962 -0.318113 1.27302 -2562 6 27.6759 22.1164 17.3809 2.93811 -8.1883 -22.8269 -2563 4 27.2909 21.5233 16.7142 1.55949 -2.9899 10.1125 -2564 4 28.0309 22.8242 16.8263 2.77593 4.45495 11.6125 -2565 6 12.9654 4.59514 18.1625 -0.934721 -11.3223 -0.518608 -2566 4 13.4589 3.798 18.4727 -12.2499 12.1104 -13.3514 -2567 4 12.4628 4.36939 17.3497 12.7979 1.84773 4.27522 -2568 6 19.7203 6.71654 19.0744 25.855 21.5282 16.2244 -2569 4 18.977 6.16103 19.2554 -18.9537 -21.446 -0.739234 -2570 4 20.1996 6.78409 19.9214 -9.72031 -0.922856 -11.6068 -2571 6 37.1527 31.3787 11.4669 20.5156 -3.08539 55.9419 -2572 4 36.5467 31.6235 12.1801 -19.4555 -0.126446 -17.2692 -2573 4 37.8531 31.0173 12.0578 -6.7166 -8.42047 -30.0342 -2574 6 3.11862 16.2015 27.3491 -14.8948 -19.7352 -9.46107 -2575 4 2.52427 15.4561 27.6487 20.3886 21.5408 -12.2486 -2576 4 3.15348 16.212 26.3649 -6.24389 -0.0501167 23.7097 -2577 6 15.7133 9.97724 38.3591 30.328 17.4212 13.8857 -2578 4 16.1258 10.8398 38.0549 -11.3336 -30.4403 16.2583 -2579 4 16.257 9.66317 39.1359 -16.0932 10.0631 -23.9552 -2580 6 13.4043 14.2884 8.2363 15.0986 25.1191 -5.83206 -2581 4 13.804 15.2225 8.33958 -5.13839 -47.7054 6.28407 -2582 4 14.0947 13.5837 8.31616 -11.6402 16.8216 1.41307 -2583 6 1.71524 24.3141 36.392 36.4901 -22.2748 31.9402 -2584 4 1.86474 25.1068 36.8985 9.35176 9.25273 5.49175 -2585 4 1.1215 24.6177 35.7571 -36.8309 10.6894 -41.0698 -2586 6 11.1862 26.5319 32.9688 15.239 -24.9993 36.2438 -2587 4 10.9649 26.8002 32.096 -11.5382 16.0703 -24.8314 -2588 4 11.1647 27.266 33.6054 -7.17864 1.89937 -11.754 -2589 6 29.5773 0.765668 36.2911 32.6527 8.9619 33.1448 -2590 4 29.1495 0.596705 35.4758 -23.483 -6.97315 -25.4485 -2591 4 28.9625 1.07408 36.9696 -5.35236 0.153158 -12.2969 -2592 6 43.6099 13.1071 23.908 -7.75428 16.7256 -33.2383 -2593 4 42.8302 13.3868 24.3919 -4.08537 -1.1131 9.93358 -2594 4 43.3622 13.2586 22.9511 7.4693 -9.27191 32.0602 -2595 6 7.44309 19.7767 19.6705 17.8438 12.6527 -6.23579 -2596 4 6.73015 19.1919 19.919 -3.61392 -10.9972 -0.189724 -2597 4 7.6227 19.7194 18.722 -11.1837 -0.704544 3.42764 -2598 6 24.4259 4.29913 7.83629 -8.5248 -0.10499 -3.36953 -2599 4 24.144 5.21077 7.98541 -0.150025 -7.47068 -3.31634 -2600 4 24.9904 4.0546 8.57206 4.90899 -0.271036 -1.18338 -2601 6 51.4883 30.2308 31.1674 -14.7545 1.56633 -0.747328 -2602 4 50.5925 29.8847 31.2768 -1.35209 3.55691 8.49804 -2603 4 51.5844 30.2463 30.2146 11.2248 2.3182 -11.9335 -2604 6 0.913373 23.6795 16.8764 44.9279 -35.4578 23.1065 -2605 4 0.053834 23.3329 16.7065 -24.7033 4.18361 -15.1926 -2606 4 1.39802 22.8443 17.1197 -4.68332 28.5423 -3.90241 -2607 6 45.0884 19.3939 15.6913 9.05154 29.148 -44.7311 -2608 4 45.9115 18.9543 15.4906 10.1171 -6.0821 0.331933 -2609 4 44.8041 18.9926 16.4702 -27.3917 -26.115 43.7395 -2610 6 17.5003 8.70625 40.5861 -20.5343 49.5779 -9.15489 -2611 4 18.1762 9.35755 40.8219 0.532033 0.318295 -4.52849 -2612 4 17.8864 7.89597 40.8225 20.4785 -39.0634 11.6529 -2613 6 30.1832 27.259 27.1983 -17.9859 30.5387 -1.70378 -2614 4 31.0843 27.5469 27.0174 5.19664 -5.65516 3.8328 -2615 4 29.6652 28.1124 27.2385 17.8651 -30.9588 0.0373123 -2616 6 43.0672 26.1987 28.3737 -1.21405 11.7795 -35.2128 -2617 4 43.2187 25.7399 27.5308 2.18298 5.51683 1.33219 -2618 4 43.1307 25.5038 29.0079 -1.74848 -11.3154 21.2466 -2619 6 27.987 7.5851 3.0601 9.13665 18.2748 23.7588 -2620 4 28.1896 6.93215 2.40721 -2.30749 -24.2619 -13.6918 -2621 4 28.5512 7.39371 3.84357 -9.52219 0.418204 -9.11945 -2622 6 44.6779 7.22362 10.1855 -3.82519 12.3682 29.7072 -2623 4 44.5846 7.37997 11.1613 -8.64186 4.71212 -23.3906 -2624 4 45.2067 6.43644 10.1815 9.68596 -14.557 -3.94398 -2625 6 23.537 20.3907 32.2607 -4.33975 0.880185 -5.57314 -2626 4 23.324 21.1985 32.7413 -3.519 5.94106 -1.71472 -2627 4 23.9311 19.8373 32.9365 5.99895 -7.24541 1.02787 -2628 6 37.5412 21.0533 29.2807 6.26587 16.0676 16.0196 -2629 4 37.3761 20.3248 28.6837 -16.0493 -11.7352 -10.5522 -2630 4 36.7218 21.4261 29.6708 7.43039 -8.09007 -9.52559 -2631 6 49.2859 29.0787 28.7031 8.16517 -18.5587 -1.11584 -2632 4 48.658 29.8007 28.598 1.09858 8.52384 -10.5349 -2633 4 50.1522 29.3365 28.3345 -7.12297 8.09394 6.40204 -2634 6 47.5144 18.1684 15.2382 -13.098 45.3115 -50.4885 -2635 4 48.063 17.6794 15.7982 26.613 -22.2712 34.0874 -2636 4 48.011 18.9832 14.9644 -13.0138 -21.3801 10.9042 -2637 6 23.2587 11.168 16.5961 -34.2623 -16.0228 11.9175 -2638 4 23.8181 11.8474 16.2701 22.3391 18.1069 -12.9732 -2639 4 23.6107 10.3074 16.3447 5.63526 2.71733 -4.05723 -2640 6 3.14661 8.32736 23.1966 -5.33081 14.6732 5.33529 -2641 4 3.33443 7.84562 22.3891 5.23826 -4.81966 -4.36628 -2642 4 3.62138 9.17513 23.1245 -2.82501 -4.35917 1.75332 -2643 6 0.508878 16.1819 6.17622 16.4304 7.97407 55.7173 -2644 4 1.47866 16.3831 6.12713 -25.5039 -9.61354 -6.44341 -2645 4 0.329178 16.1408 7.1857 2.48639 -0.0834422 -46.7437 -2646 6 43.1796 15.6993 5.84098 -15.9449 -20.1226 -10.4934 -2647 4 42.9586 16.4507 6.36104 0.864404 19.5468 17.3894 -2648 4 44.0486 15.8407 5.47017 17.9332 8.6581 -2.45416 -2649 6 16.7038 35.4743 34.4518 -23.198 12.4372 32.502 -2650 4 15.9504 35.0582 34.0028 7.47206 -3.63127 2.95791 -2651 4 16.3197 35.7905 35.3305 20.1374 -9.24319 -26.2799 -2652 6 38.8854 7.73874 15.6833 27.6202 35.8952 13.402 -2653 4 39.2486 7.07212 15.1014 0.737034 -8.76325 -8.48971 -2654 4 39.6641 8.33099 15.9666 -32.1226 -27.7665 -11.1551 -2655 6 42.0076 36.5182 13.641 -8.45099 16.164 -4.64077 -2656 4 41.9228 35.5752 13.5656 2.538 -16.9665 4.44933 -2657 4 41.1544 36.8356 13.3036 3.7559 4.14555 2.82714 -2658 6 54.2986 15.3848 32.1119 10.5246 -16.1102 10.831 -2659 4 0.035655 15.9755 32.3754 -8.42237 -3.15332 1.00609 -2660 4 53.5781 15.9253 31.7943 -3.3302 7.96061 -4.64421 -2661 6 22.8954 13.9973 39.0304 35.7671 -1.21675 7.49641 -2662 4 23.2761 14.8055 39.421 -4.93619 -7.73369 -6.00904 -2663 4 21.9819 14.1606 38.8837 -32.0989 6.28079 -4.51925 -2664 6 48.0426 28.53 4.78367 -18.7604 -12.0579 33.007 -2665 4 48.5209 28.7824 4.01456 21.1512 11.8238 -22.7946 -2666 4 47.6247 29.3288 5.14776 5.26678 3.3179 -1.38234 -2667 6 48.833 10.6059 2.66638 -9.19187 -9.9608 -41.9733 -2668 4 48.2371 10.184 3.25557 -19.2293 -15.3999 15.8868 -2669 4 49.4018 11.1117 3.19515 27.1663 25.8201 26.2609 -2670 6 17.1043 29.3494 4.41938 0.116954 -3.05469 4.91749 -2671 4 16.3442 28.823 4.73493 -1.75912 12.177 1.49975 -2672 4 17.4207 29.929 5.14153 -0.429925 -17.6765 -0.899977 -2673 6 27.7901 7.33424 26.577 58.6208 -10.7281 -9.65958 -2674 4 28.6921 6.89516 26.6033 -20.1634 35.8081 4.28732 -2675 4 27.2961 6.54785 26.6418 -36.3357 -24.7905 3.70209 -2676 6 18.0242 22.0537 22.5144 -27.9591 -16.1551 -40.0832 -2677 4 18.4878 21.2118 22.5153 10.7066 -2.42354 6.7168 -2678 4 17.4966 21.98 21.6478 21.0889 16.8172 36.9195 -2679 6 22.144 25.0979 16.6837 -22.767 31.6961 -6.75713 -2680 4 21.8754 25.6012 15.8609 3.46788 -12.1894 37.0641 -2681 4 22.4796 24.2953 16.3382 13.1119 -24.3628 -7.92486 -2682 6 25.5147 28.4379 7.13209 -32.2353 18.5879 42.0502 -2683 4 25.3191 28.6153 8.09624 16.8162 -18.2828 -29.7283 -2684 4 25.4949 29.3399 6.82105 5.5127 9.28731 -21.7507 -2685 6 42.5447 24.7469 23.7482 -26.0567 17.8354 -0.260974 -2686 4 41.659 25.0561 24.0862 27.8337 1.55541 -7.56443 -2687 4 42.5141 23.8045 23.8516 -5.7883 -22.6777 0.706816 -2688 6 6.24511 16.6188 2.47068 -21.6781 9.7655 5.77715 -2689 4 5.36273 16.9874 2.41541 -6.24724 13.8235 -1.18511 -2690 4 6.01398 15.7093 2.58331 16.9883 -26.009 1.35247 -2691 6 47.3719 33.28 1.46148 -3.99946 1.01934 -28.2481 -2692 4 46.9803 34.1218 1.66358 -4.59906 12.9067 -8.65937 -2693 4 47.69 33.0389 2.30921 14.6803 -12.3184 23.7614 -2694 6 1.27616 36.1851 24.8829 8.16993 1.58395 -5.27854 -2695 4 0.639753 36.4584 25.5359 -13.8461 11.829 3.50901 -2696 4 1.57271 35.3754 25.2942 10.46 -9.74103 -2.86729 -2697 6 20.9413 29.0442 16.4303 -37.0385 3.95749 11.2157 -2698 4 21.4069 28.5201 15.8013 19.747 -14.8546 -14.4583 -2699 4 21.4101 29.8248 16.6953 16.4704 9.62387 -0.234111 -2700 6 18.6701 32.5426 14.1399 -11.935 -28.2137 10.094 -2701 4 17.8036 32.9051 14.2078 -15.3524 29.2867 2.90472 -2702 4 18.4356 31.618 14.3552 23.1856 4.50503 -1.59621 -2703 6 15.7338 41.7002 0.007017 -29.1796 -38.8659 -6.04008 -2704 4 15.5134 41.1073 41.1476 16.5192 17.684 16.0218 -2705 4 15.1804 41.3134 0.738607 16.9589 18.7767 -12.0866 -2706 6 20.5358 18.4015 7.20723 -36.4209 10.7746 11.3165 -2707 4 20.1727 18.4996 8.12034 18.5895 1.11111 -8.73102 -2708 4 19.7156 18.4439 6.66948 20.5956 -6.66311 2.45516 -2709 6 35.3359 2.82506 1.61733 -4.03181 47.7257 29.2165 -2710 4 34.9541 3.20961 2.47337 19.1106 -23.159 -34.5889 -2711 4 35.8528 3.61912 1.28524 -9.69035 -30.1723 1.40188 -2712 6 49.0059 19.6751 24.9502 -26.306 10.305 -4.58994 -2713 4 49.8292 19.282 24.7191 18.9727 -16.8119 -2.00329 -2714 4 49.219 20.61 24.9195 -6.54834 1.96917 8.98321 -2715 6 26.0427 7.1974 41.5664 19.1127 -25.9459 -27.3591 -2716 4 26.6886 6.46136 41.6822 -6.92827 19.3426 1.38611 -2717 4 25.5576 7.23966 0.456505 -11.7101 6.8047 33.8929 -2718 6 22.0248 3.60461 29.0185 -16.0846 7.25678 -9.40108 -2719 4 21.194 3.80897 28.5456 14.569 -4.87522 0.502932 -2720 4 22.1959 4.40114 29.525 4.81678 0.210141 7.58007 -2721 6 27.8548 32.5394 20.644 30.2008 -27.0251 30.2495 -2722 4 26.9598 32.7332 20.4747 -36.3343 12.7784 -11.814 -2723 4 28.412 33.1097 20.1287 0.615935 11.6015 -11.5439 -2724 6 8.3956 24.7909 3.45677 41.8783 30.6212 2.1827 -2725 4 8.85983 24.2427 2.83372 10.4085 -11.4169 -11.9204 -2726 4 7.65564 24.3184 3.74512 -41.6031 -24.257 6.19876 -2727 6 30.5856 41.7288 15.6573 18.8319 11.6475 40.5199 -2728 4 29.9513 0.161741 16.3149 8.82373 -8.1621 -4.69308 -2729 4 30.0935 41.6309 14.8822 -24.2072 -8.84927 -42.274 -2730 6 48.0984 5.63232 21.2085 -24.8678 -8.67647 -10.7387 -2731 4 47.6235 6.28714 20.6867 8.63769 7.09972 -0.446275 -2732 4 47.3595 5.05066 21.4474 12.3779 0.983941 9.20385 -2733 6 39.4236 23.163 35.7324 -26.6807 -22.8308 -31.4054 -2734 4 39.8477 23.6904 36.3502 31.9199 30.6139 46.0523 -2735 4 38.8623 22.5516 36.2186 -1.29306 -3.58423 7.04543 -2736 6 51.5883 33.3617 5.78995 -19.5798 -55.0773 -18.3228 -2737 4 51.7861 34.2574 5.89467 9.96767 53.6603 7.25336 -2738 4 51.5145 33.1869 4.82901 1.99858 6.27826 11.2132 -2739 6 40.1205 17.6413 30.7797 3.51386 -32.8888 9.0941 -2740 4 39.6335 18.3955 31.0853 6.47279 10.0891 -2.42254 -2741 4 40.8254 17.9321 30.1952 -5.08805 1.72673 -6.80625 -2742 6 46.4235 9.81086 18.5807 -13.6096 13.2326 25.0066 -2743 4 47.164 10.4099 18.4597 3.17276 -2.49269 -0.272695 -2744 4 46.3941 9.2422 17.832 2.02048 -17.819 -25.0993 -2745 6 15.8844 41.0843 31.9336 24.9021 -3.26155 -16.7898 -2746 4 16.5805 40.7078 31.3592 -9.31569 -10.1627 6.74042 -2747 4 16.1791 0.090931 31.8861 -11.051 9.97246 9.22539 -2748 6 48.5496 25.7276 14.9325 -23.4699 4.48431 -20.1118 -2749 4 49.4421 25.9075 14.7294 36.7388 1.67727 3.80263 -2750 4 48.1707 25.827 14.039 -11.0362 0.596064 15.3478 -2751 6 39.2225 28.9892 36.1575 1.81804 -9.3363 -11.5399 -2752 4 40.0459 29.1043 36.6225 6.32097 13.8964 11.0865 -2753 4 39.5169 28.7877 35.2623 -5.25992 -5.15898 -10.721 -2754 6 37.325 21.0738 14.9394 -7.85324 -20.9229 -64.7065 -2755 4 37.9996 20.7799 14.2865 -1.58038 10.9233 26.036 -2756 4 36.5898 21.2349 14.28 11.1979 5.88457 46.2171 -2757 6 32.4971 22.8607 15.7433 -7.91212 -33.4559 24.7905 -2758 4 31.7632 22.4534 15.25 1.55934 10.0805 -2.32687 -2759 4 32.5592 22.2921 16.5663 4.31702 21.463 -27.4441 -2760 6 18.5773 8.13014 37.5708 2.8796 34.5567 21.0854 -2761 4 19.1021 8.93687 37.8089 1.20854 -19.8484 -10.1251 -2762 4 17.9431 8.09722 38.288 -3.97249 -3.14491 3.87795 -2763 6 46.9308 30.3817 11.0144 7.20248 -9.32119 -46.6603 -2764 4 46.4987 30.7035 10.1833 6.25688 -3.94108 30.979 -2765 4 47.431 29.6318 10.6212 -6.26387 6.19468 23.2459 -2766 6 54.6355 13.051 30.6677 -0.631529 -12.3617 0.377161 -2767 4 54.9401 12.1973 31.0202 -4.70537 6.73717 3.83911 -2768 4 54.6706 13.679 31.4001 -0.542159 7.57402 -2.77471 -2769 6 32.2973 35.1412 27.9506 0.702746 7.41177 51.9011 -2770 4 32.3519 35.6753 28.7977 -4.11304 1.55554 -34.3644 -2771 4 32.0809 34.2722 28.2835 1.42742 -15.3938 2.35714 -2772 6 4.45353 25.396 31.7914 -28.2716 -32.1048 1.32297 -2773 4 5.00928 24.905 32.4172 3.79617 9.45861 3.32159 -2774 4 4.83781 26.2295 31.6234 26.2458 34.1175 0.407684 -2775 6 40.7781 38.1509 21.8521 -13.1408 -33.509 11.5706 -2776 4 40.6716 39.044 22.1698 7.33695 21.0707 -1.24628 -2777 4 41.4481 38.0623 21.1738 10.5508 14.8215 -9.14642 -2778 6 26.6931 9.85845 27.4042 -43.8759 24.145 24.882 -2779 4 26.9952 9.1619 26.8761 23.7363 -35.7414 -23.7206 -2780 4 25.7673 9.60487 27.6152 14.5566 8.07269 5.62533 -2781 6 53.3967 39.4485 11.7649 68.843 -10.0355 -14.0333 -2782 4 54.4148 39.3855 11.5456 -53.2103 8.20916 12.7106 -2783 4 53.105 40.2482 11.2866 -1.29569 -7.05369 14.3337 -2784 6 35.3292 21.4155 2.23587 15.106 -7.83484 -18.4876 -2785 4 34.912 20.5764 2.48744 -1.27765 6.93695 -0.309601 -2786 4 35.8084 21.2289 1.37944 -21.1629 3.53466 26.6292 -2787 6 4.14409 17.1449 33.9131 -16.1644 -22.9901 22.0601 -2788 4 4.14131 16.4411 34.6063 8.69636 10.7601 -14.4963 -2789 4 3.20404 17.192 33.6728 6.06844 1.20479 -9.99864 -2790 6 24.1486 16.1886 14.6752 2.90394 -28.6462 -21.9437 -2791 4 24.2343 17.059 15.0346 0.494679 15.8947 1.83084 -2792 4 23.7735 16.3203 13.7888 -2.47926 -0.947779 4.85435 -2793 6 43.1303 2.83022 26.0988 7.42094 18.4339 -15.1049 -2794 4 42.3152 3.21229 26.4285 -6.54764 -1.84254 4.96768 -2795 4 43.2129 3.23454 25.2082 4.91034 -11.1878 11.8147 -2796 6 40.68 12.1827 1.56051 12.2683 5.96873 16.2718 -2797 4 41.5968 12.2158 1.84207 12.0551 -6.37233 -9.83141 -2798 4 40.2741 12.5174 2.36876 -21.9125 -2.35909 -10.0625 -2799 6 47.3781 8.09655 26.7608 82.0606 26.064 -7.54845 -2800 4 46.666 7.67998 26.3919 -67.6244 -33.3987 -26.4118 -2801 4 48.0445 8.01522 26.0221 -12.6559 5.80771 33.8866 -2802 6 35.8947 30.7223 38.5098 17.2216 52.6179 -38.6143 -2803 4 35.6523 29.9703 39.0072 10.7188 -28.2359 27.6772 -2804 4 36.8587 31.0199 38.5623 -37.3038 -25.1724 3.03639 -2805 6 51.3054 23.2176 32.4969 -40.2617 11.1267 -4.72183 -2806 4 51.571 23.9803 31.9692 8.10126 9.10595 3.65824 -2807 4 52.0738 22.7076 32.6523 27.5758 -14.8312 4.00399 -2808 6 30.6066 4.44965 39.6625 0.615077 -4.04577 -5.4494 -2809 4 30.9728 3.64581 40.0124 3.38991 -22.1323 -0.234101 -2810 4 30.7691 5.02119 40.3987 0.467535 29.3806 6.08815 -2811 6 35.2584 29.6988 2.86074 -18.8762 -20.4699 -30.2285 -2812 4 35.7444 29.7805 2.00551 -3.31399 -2.84145 17.507 -2813 4 34.478 29.0852 2.62897 29.9452 30.586 13.9144 -2814 6 50.3064 26.1399 9.38994 -11.2342 14.6262 -3.47403 -2815 4 49.9288 26.8854 8.86032 11.0364 -25.2497 6.23881 -2816 4 49.6695 25.4035 9.37359 7.94529 9.32604 -3.86417 -2817 6 50.1026 36.8163 26.4125 -14.5138 -5.51826 -11.285 -2818 4 49.5888 36.0167 26.6617 3.79204 13.187 5.56915 -2819 4 50.2319 37.3727 27.1922 -3.20057 1.11223 6.19844 -2820 6 40.3045 23.9511 38.5442 56.3682 27.7758 -3.16545 -2821 4 40.8125 24.7624 38.7991 -6.5383 -29.3065 -12.768 -2822 4 39.4568 24.2221 38.8139 -44.6373 -1.162 12.0349 -2823 6 24.9504 10.7612 30.6561 23.3702 -4.90777 36.4738 -2824 4 25.6234 10.7245 31.4083 -25.7901 9.07318 -40.0098 -2825 4 24.9126 11.6687 30.2959 1.4184 -10.5997 2.42613 -2826 6 5.89627 1.02238 5.41014 -10.9637 -3.10309 -8.95081 -2827 4 5.14436 0.409378 5.47088 11.7326 -0.810065 6.31118 -2828 4 6.70289 0.529043 5.60145 -0.696658 -1.4992 -0.407558 -2829 6 44.282 29.3718 26.2736 69.4655 -24.0165 25.5627 -2830 4 43.5561 29.7046 25.8233 -49.9183 11.7173 -34.3685 -2831 4 44.8903 28.8623 25.6892 -19.9675 5.54095 9.74148 -2832 6 25.3119 10.1784 6.67292 -15.7736 -23.3412 -3.06725 -2833 4 25.6521 11.0537 6.64576 10.6351 24.7362 -4.37451 -2834 4 25.4625 9.79379 5.79618 6.21987 0.326131 1.26241 -2835 6 13.3514 28.0662 2.56722 45.2358 13.6418 17.9819 -2836 4 12.4545 27.8107 2.56105 -32.9681 -11.4511 -11.8173 -2837 4 13.8041 27.7134 1.79344 -6.10921 -0.687749 -0.120894 -2838 6 6.44709 40.2351 18.0254 21.2427 9.30891 -1.39987 -2839 4 6.966 39.4726 17.7533 0.137807 -7.29984 6.20872 -2840 4 5.59682 40.0602 17.6456 -22.1821 0.316247 -4.7234 -2841 6 47.7944 13.5061 2.01255 -17.6425 -30.8617 30.605 -2842 4 48.2016 12.6358 2.19438 -7.04124 7.54818 -3.24284 -2843 4 48.4122 13.9735 1.50015 28.8905 20.8749 -24.4455 -2844 6 13.5944 20.2974 2.4458 20.0315 11.2691 18.6487 -2845 4 13.7883 19.6075 3.10831 1.39134 9.87367 -8.40212 -2846 4 13.0064 19.8713 1.85297 -21.5499 -10.3053 -19.2062 -2847 6 15.2336 0.850818 36.6661 8.37652 40.6516 -23.9146 -2848 4 15.3117 1.46746 37.4264 -6.40063 -24.0213 -7.24367 -2849 4 15.3514 1.51981 35.909 -6.71396 -40.605 26.1829 -2850 6 33.5971 35.2491 15.0847 71.6425 -10.6997 11.4711 -2851 4 33.8969 35.3297 16.0058 -20.0956 -0.49545 -2.4869 -2852 4 34.508 35.0431 14.6807 -47.978 4.31732 -2.67502 -2853 6 21.7981 9.23698 0.429299 24.0185 -25.5324 29.6504 -2854 4 22.426 9.07175 41.6424 8.6426 -4.20457 -11.04 -2855 4 21.1884 9.81045 0.032847 -35.1273 25.1593 -17.3244 -2856 6 38.1453 27.4709 3.0333 47.9463 -55.6761 10.6859 -2857 4 37.7532 27.3037 2.19157 -17.0599 1.14667 -24.2168 -2858 4 37.8405 28.2288 3.44687 -27.291 50.0057 16.1216 -2859 6 38.8714 27.215 11.7709 41.141 -36.7506 -15.3879 -2860 4 38.9285 26.3434 12.2193 -14.3396 10.7389 0.963039 -2861 4 39.5886 27.0941 11.0922 -22.6073 11.6268 16.0227 -2862 6 29.8734 41.5737 28.6987 15.2279 35.2113 -10.5566 -2863 4 28.9552 41.3162 28.7047 -13.1778 -5.77603 2.88395 -2864 4 29.9141 0.263017 27.9132 -0.896253 -12.9147 16.3719 -2865 6 34.03 8.70777 38.0687 38.5763 27.6628 16.1728 -2866 4 34.8607 8.18924 38.1985 -14.88 11.0383 -8.6682 -2867 4 33.3419 8.15213 37.7593 -24.3719 -27.4308 -8.08559 -2868 6 38.8091 27.3495 30.6738 6.32435 -21.1782 -4.52762 -2869 4 38.5154 26.4386 30.4378 -1.34454 21.7952 1.35616 -2870 4 38.3686 27.5808 31.4849 -11.9448 1.82739 7.69603 -2871 6 41.6473 17.269 36.3639 7.45605 15.5752 1.52238 -2872 4 41.3137 17.162 35.483 -10.4634 0.342165 -15.0979 -2873 4 41.7169 16.3923 36.7151 5.72978 -18.5967 8.16978 -2874 6 30.7243 26.977 35.2074 -15.5404 -28.2563 -3.1326 -2875 4 31.3953 27.4345 34.7177 18.5093 15.4635 -5.31058 -2876 4 30.2206 27.5565 35.766 -0.690558 20.2492 9.56945 -2877 6 47.5414 4.09198 27.2867 -2.42911 13.6608 18.2544 -2878 4 46.636 4.37242 27.4325 -10.4037 -2.52064 9.15115 -2879 4 47.5606 3.99786 26.3497 6.55325 -3.96267 -23.0579 -2880 6 20.946 8.39203 7.27322 -27.8597 -45.7319 -0.818331 -2881 4 20.9365 8.74812 8.15774 -0.207227 20.4039 13.5637 -2882 4 21.4094 8.93893 6.67191 21.7448 31.5979 -18.7028 -2883 6 36.8544 13.691 0.855516 -6.96494 -6.58957 -4.7536 -2884 4 37.3845 13.474 1.605 15.5913 2.53244 29.7992 -2885 4 37.0002 12.9032 0.328977 -4.78774 -2.28905 -12.5933 -2886 6 28.5904 20.2994 26.4544 16.2695 -3.42806 -15.5352 -2887 4 28.4835 19.402 26.1318 -1.12761 -3.3858 2.90642 -2888 4 27.7814 20.5406 26.8733 -22.93 6.76513 15.2817 -2889 6 51.6079 16.8571 33.5121 -4.50033 -4.43314 5.93611 -2890 4 51.6159 16.0837 34.101 -3.91985 -0.958274 -7.09147 -2891 4 50.9053 16.6875 32.8669 7.1497 -2.58651 -2.16023 -2892 6 16.2715 32.0073 37.6936 -41.8913 -21.032 -18.7972 -2893 4 16.4093 31.405 38.4555 0.0363557 12.0183 -19.687 -2894 4 15.4977 31.6058 37.1477 38.3353 16.8511 22.6146 -2895 6 14.3407 25.877 13.2155 1.26588 11.3619 -17.2713 -2896 4 13.5013 26.0279 13.6901 5.40221 7.27027 -0.947788 -2897 4 14.4551 26.5608 12.5093 -9.57117 -0.277473 20.5459 -2898 6 54.9749 28.8768 3.30374 1.15612 -53.5629 -1.59986 -2899 4 54.8083 28.9028 2.3467 2.04661 0.129141 5.0455 -2900 4 0.26744 27.9124 3.48546 -12.4506 41.1861 -2.95604 -2901 6 17.22 5.15598 2.57931 -12.7888 -35.846 -9.7104 -2902 4 17.8674 4.52191 2.91459 -1.87097 -9.90488 -4.08214 -2903 4 17.421 5.9071 3.09191 1.36943 25.6696 10.0797 -2904 6 50.6995 33.0507 10.3154 6.59719 15.9916 42.5002 -2905 4 50.6222 33.8517 9.79386 -1.28667 2.08485 -11.8542 -2906 4 50.7575 32.2667 9.79209 -3.80283 -15.7636 -22.9095 -2907 6 28.8826 19.8405 32.3742 18.5732 17.2051 -15.397 -2908 4 29.8373 20.0763 32.2 -31.4986 -11.6613 7.66973 -2909 4 28.4094 20.6578 32.1253 1.55933 -8.77069 7.582 -2910 6 22.4307 12.8248 23.2991 -20.6917 10.5217 33.6658 -2911 4 22.5556 12.3422 24.1574 -2.40655 13.6672 -16.3005 -2912 4 21.7108 13.488 23.4947 18.3613 -16.8762 -11.246 -2913 6 54.7763 15.5394 8.86893 2.10476 3.1215 13.1486 -2914 4 0.465115 15.309 9.51431 10.762 -2.70861 -3.02895 -2915 4 53.9989 15.1653 9.30174 -3.31272 -0.629746 -12.248 -2916 6 10.4518 19.2967 26.1704 43.67 -11.1159 60.7251 -2917 4 11.2502 18.7163 26.2348 -22.5321 13.8961 -6.48776 -2918 4 10.166 19.2541 25.3007 -24.1973 -3.18459 -58.4054 -2919 6 38.6496 20.2998 35.2325 20.2193 -0.813999 -8.63065 -2920 4 39.5955 20.3672 34.9603 -17.6326 -1.16496 9.70871 -2921 4 38.5782 19.6093 35.9099 2.97533 6.68842 -2.65526 -2922 6 17.4906 18.0487 15.2499 -10.3405 45.0299 20.0184 -2923 4 17.3837 17.5615 14.4531 -8.22833 -15.0257 -32.2828 -2924 4 17.2318 18.9864 14.9797 13.5676 -28.3997 10.204 -2925 6 29.6331 0.960567 26.2796 -25.6031 -26.3316 -72.4206 -2926 4 29.3216 1.74647 25.7973 3.40072 6.61544 23.4347 -2927 4 29.2407 0.266373 25.6265 23.6279 16.4272 47.4057 -2928 6 30.4665 12.6849 28.2971 -10.7965 -27.9245 1.17671 -2929 4 29.8272 13.0822 27.7097 -1.40549 16.7134 -9.61387 -2930 4 30.1324 11.7665 28.3519 9.60572 9.94425 5.65357 -2931 6 36.6695 22.1225 33.3577 39.6017 -11.6369 -25.7224 -2932 4 37.5338 21.6663 33.4931 -10.4393 24.3252 -8.31461 -2933 4 36.1732 21.6976 34.0074 -34.1256 -9.27026 38.9845 -2934 6 34.8672 22.4666 14.3113 -12.0535 -16.0605 -66.2467 -2935 4 34.0349 22.4515 14.7407 -19.1997 11.5289 38.0952 -2936 4 34.5417 22.174 13.4128 25.6484 2.69091 24.3313 -2937 6 15.5262 9.60919 7.44527 49.3682 -27.3699 -19.0187 -2938 4 16.547 9.52246 7.26069 -54.7763 6.57045 5.33777 -2939 4 15.1277 8.71762 7.26288 7.76902 16.5773 17.8238 -2940 6 21.8158 28.0339 19.8054 -4.91607 2.79332 -16.2053 -2941 4 21.8614 28.4614 20.6522 -2.04715 7.82991 15.4338 -2942 4 20.8734 27.9328 19.6183 -0.9528 -10.4666 6.26348 -2943 6 34.5348 24.4247 2.43569 30.4222 -68.2311 14.7367 -2944 4 34.4753 23.4054 2.32054 1.69344 45.6403 0.121788 -2945 4 35.3397 24.4934 3.03523 -29.9154 15.8849 -16.545 -2946 6 12.599 20.9348 33.4989 -13.8827 -5.0407 19.8786 -2947 4 11.7591 20.6911 33.9854 14.8004 1.51093 -27.4282 -2948 4 12.4712 20.9089 32.5331 -6.4324 -2.96843 13.903 -2949 6 45.7737 31.1538 8.70434 -2.26925 11.3362 1.64289 -2950 4 45.9542 32.0869 8.96415 -8.39554 -11.7705 -15.6468 -2951 4 44.8313 30.9442 8.82297 5.93432 7.3758 2.64979 -2952 6 15.4817 22.5529 30.1787 5.69125 -30.6905 2.54506 -2953 4 16.2669 22.9885 30.4865 5.73919 23.8488 1.47991 -2954 4 15.7828 21.6299 30.2043 -15.5749 7.04719 -4.74998 -2955 6 39.7421 17.1743 38.4094 21.5551 17.0277 -9.47446 -2956 4 39.5031 16.7163 37.59 -3.21419 -6.16335 13.1695 -2957 4 40.5012 17.7258 38.123 -12.3818 -10.233 9.13463 -2958 6 13.9944 24.6739 0.675362 16.6213 17.4065 1.77653 -2959 4 14.3534 24.6315 1.57006 -7.52322 -5.04497 4.60086 -2960 4 14.2363 25.5684 0.403337 7.11699 -3.23043 -4.31609 -2961 6 31.5223 19.5616 3.57151 -53.5885 6.24325 20.3398 -2962 4 30.9852 19.2876 4.35912 8.49606 10.2921 -25.2864 -2963 4 32.3806 19.3906 3.88708 44.0272 -8.41539 -5.41474 -2964 6 36.1052 25.07 19.4414 -58.1964 5.4792 30.944 -2965 4 37.0178 24.9674 19.4291 53.7837 8.57858 1.17104 -2966 4 35.8724 24.6048 18.6565 -11.4284 -6.26335 -25.0938 -2967 6 51.6856 17.6883 14.8068 3.37141 18.4291 36.2611 -2968 4 51.7159 18.5692 15.274 12.631 -26.1695 -13.2311 -2969 4 51.0805 17.8845 14.1157 -15.036 4.32684 -29.7308 -2970 6 37.7054 27.4905 38.1961 21.1085 51.9404 -4.50496 -2971 4 37.7442 26.8536 37.5026 -5.7586 -24.9449 -15.2301 -2972 4 38.1753 28.2651 37.7886 -14.569 -23.1779 14.5181 -2973 6 34.7911 13.8542 30.7834 63.814 8.34946 -38.9004 -2974 4 35.1479 14.6416 31.2053 -8.52888 3.60926 11.6955 -2975 4 33.9958 13.5796 31.1473 -54.5977 -12.3598 32.1143 -2976 6 19.6332 37.3754 39.9698 -24.3625 -2.8653 -8.02349 -2977 4 20.5737 37.5051 40.1221 10.6449 -2.37562 -1.97502 -2978 4 19.476 36.9037 39.1231 9.83703 4.21653 7.37417 -2979 6 40.9393 34.0697 21.4586 2.1394 -11.0927 -27.2527 -2980 4 41.1855 34.0244 22.3739 -0.995015 -5.02364 12.6588 -2981 4 40.8269 33.1391 21.1809 -5.56645 12.5591 1.05516 -2982 6 32.9542 27.2131 26.5676 21.8236 31.3611 42.3808 -2983 4 33.7455 27.7378 26.9411 -38.3522 -19.3744 -9.62352 -2984 4 33.2804 26.8388 25.7801 14.7034 -8.88898 -37.5519 -2985 6 24.4045 18.6625 15.6046 15.6323 5.3487 0.0952382 -2986 4 23.6496 19.2317 15.7207 -14.8084 -1.4602 1.41466 -2987 4 24.5649 18.2576 16.462 -0.219489 -3.50303 9.55317 -2988 6 29.9663 1.63299 9.06934 -19.1782 58.0281 -13.4952 -2989 4 30.0652 0.728361 9.20589 6.15764 -53.3299 8.23098 -2990 4 29.142 1.69178 8.53744 13.8409 -0.846673 8.85197 -2991 6 31.4884 20.0987 7.87879 28.0207 -11.7442 -56.0977 -2992 4 31.929 19.6692 7.07379 -7.62771 20.3934 38.6055 -2993 4 30.8102 19.4535 8.0257 -16.4635 -8.90407 20.6678 -2994 6 35.0404 3.79156 33.2694 -1.07326 -4.91424 22.8916 -2995 4 34.2545 4.23611 32.9039 10.815 -2.65177 -4.17514 -2996 4 34.969 3.91026 34.2418 -2.62674 -1.77539 -18.1187 -2997 6 43.9504 7.96546 12.9857 17.1829 -21.9111 0.113786 -2998 4 43.3325 7.29581 13.3448 8.44862 12.3123 -3.96012 -2999 4 43.4563 8.73573 12.7333 -15.1408 11.4953 0.0339333 -3000 6 44.1156 32.6759 16.9403 5.31814 23.9263 4.94933 -3001 4 44.7028 33.4557 16.8081 -6.11209 -18.3833 -3.28173 -3002 4 44.1603 32.5425 17.8901 -3.26507 -3.06823 6.73624 -3003 6 40.6044 27.171 19.0399 5.35236 -7.54795 -39.8413 -3004 4 39.9756 26.4797 18.7399 3.73803 11.5815 8.49028 -3005 4 41.0398 27.5246 18.2027 -12.4172 -8.32437 32.3474 -3006 6 46.047 23.2024 29.047 17.2683 37.2743 26.3298 -3007 4 46.6657 23.8797 29.4684 -18.5589 -27.346 -17.4569 -3008 4 46.486 22.3548 28.9238 8.34839 -6.65718 2.80441 -3009 6 42.6215 30.6103 18.862 -5.01232 -15.325 -26.4249 -3010 4 43.5272 30.7476 19.0895 18.324 11.0008 12.4889 -3011 4 42.704 29.9429 18.1625 -17.0641 3.12823 2.85026 -3012 6 36.1251 10.8932 23.2678 23.6581 36.1082 4.04534 -3013 4 35.2523 11.2865 23.1129 -2.80799 -1.69562 1.02392 -3014 4 36.6983 11.6913 23.4963 -28.2294 -33.6871 -7.78786 -3015 6 13.7386 31.5223 15.7271 -4.49361 3.73805 -16.8081 -3016 4 14.6779 31.7192 15.7387 3.94655 -1.56597 5.72926 -3017 4 13.381 32.0318 14.979 -1.5565 -4.12563 8.0657 -3018 6 33.1703 41.4275 27.7797 10.5813 -15.702 68.4674 -3019 4 32.9714 0.101499 27.0951 -7.66273 31.9341 -41.1766 -3020 4 33.2579 0.043937 28.6255 4.60937 -17.5422 -27.6682 -3021 6 32.9019 22.9042 31.4856 -22.5274 37.748 -5.90861 -3022 4 32.2895 23.1741 30.7829 6.44322 -22.1433 -13.1277 -3023 4 32.7242 23.6662 32.0583 13.0029 -8.58894 11.8377 -3024 6 27.6559 16.8629 6.38841 0.759442 -6.33883 29.8789 -3025 4 27.8611 17.2083 5.54221 8.69809 17.4791 -25.8043 -3026 4 26.8031 16.4594 6.24591 -13.957 -6.38022 2.63501 -3027 6 47.2651 11.6173 26.0576 8.33461 35.0159 47.6166 -3028 4 47.0912 11.6838 27.0214 -5.10661 -22.4254 -22.6877 -3029 4 47.7461 12.4597 25.9756 -3.10554 -9.06377 -24.8427 -3030 6 27.5595 7.06242 7.64189 36.0057 -29.1625 5.70238 -3031 4 26.7484 7.49683 7.83093 -25.0876 11.7282 17.2448 -3032 4 28.0841 6.86482 8.45622 -15.7481 15.6684 -17.1357 -3033 6 39.8009 9.06823 11.973 -19.1879 4.0297 -12.8881 -3034 4 39.4826 9.27056 11.0665 6.39012 -4.37616 15.6201 -3035 4 38.9894 9.1094 12.5089 2.28999 7.64442 -1.09803 -3036 6 18.1977 33.4656 36.103 -47.2434 1.22325 7.58723 -3037 4 17.6693 33.9565 35.4324 13.0563 -6.22307 9.58411 -3038 4 17.491 33.069 36.7104 31.5801 5.82297 -20.8408 -3039 6 37.1917 26.5507 0.720984 -4.45309 15.6177 5.32368 -3040 4 37.3846 25.6567 0.44907 -1.85313 -8.64798 -1.56679 -3041 4 36.2207 26.6114 0.739208 8.96605 -1.46339 -9.13916 -3042 6 44.1887 19.6251 36.8885 40.0452 -6.58607 -3.19327 -3043 4 45.0262 19.1233 36.6753 -25.2412 9.90919 11.1214 -3044 4 44.4881 20.5478 36.9825 -7.95545 -4.32402 -1.12283 -3045 6 27.7744 6.35339 35.6933 13.1235 -8.00403 1.40836 -3046 4 27.1655 6.97567 35.3121 -8.4989 9.93248 -6.95364 -3047 4 27.2748 5.53908 35.7675 0.865215 -2.72076 5.22838 -3048 6 34.7673 16.4826 20.8897 25.0208 -26.1622 5.09639 -3049 4 35.5801 15.8751 20.9364 -40.3091 28.8833 0.638889 -3050 4 34.1629 16.1653 21.5964 8.34467 8.45669 -12.6288 -3051 6 39.0349 20.9701 40.4369 -35.0548 -83.2732 -20.3586 -3052 4 38.7355 20.0763 40.8679 21.616 52.9309 -20.1646 -3053 4 39.3277 21.5521 41.0958 10.956 28.6509 41.127 -3054 6 10.8075 27.9275 1.66251 45.0798 11.5101 -39.3642 -3055 4 10.1207 27.6506 2.20454 -46.3214 -11.9312 37.0665 -3056 4 10.864 28.8887 1.77269 -0.956148 -2.75571 -0.87801 -3057 6 47.0235 23.1304 13.2457 -34.1648 -14.46 -9.62139 -3058 4 47.6809 23.5773 12.718 7.19949 7.22116 -4.18429 -3059 4 46.2703 22.9258 12.6132 27.3011 3.73645 28.26 -3060 6 34.5862 28.4037 10.6629 -11.4192 -4.75939 1.42695 -3061 4 34.4799 27.7252 11.3319 -5.35328 -3.69815 4.40234 -3062 4 35.5403 28.4214 10.6073 9.29856 11.2923 -14.2157 -3063 6 3.3474 17.5828 14.2796 -19.4871 24.8451 -12.2706 -3064 4 3.54237 16.6973 14.5399 7.15819 -24.2504 13.4427 -3065 4 3.84281 18.1577 14.8755 9.98901 -5.90389 -1.38432 -3066 6 27.7213 11.5993 7.52196 5.39723 39.0715 -5.17771 -3067 4 27.6701 12.604 7.61024 4.43832 -37.6789 -1.1729 -3068 4 27.2296 11.2227 8.25132 -2.72363 -3.1191 8.53492 -3069 6 41.4314 28.3382 9.01837 19.0589 -0.973961 -18.7609 -3070 4 40.8555 28.7961 9.62238 -6.75468 20.1798 6.66135 -3071 4 41.7073 28.957 8.28743 -10.8025 -14.2077 17.7393 -3072 6 42.0854 4.7797 8.18851 -21.257 14.5957 -52.3899 -3073 4 42.0432 5.70949 7.81908 14.9695 -22.9802 20.9203 -3074 4 41.8649 4.22501 7.38905 12.6142 12.8494 32.4876 -3075 6 28.4682 8.6325 40.3242 -61.7219 6.47809 -5.55454 -3076 4 27.7379 8.57122 40.9835 27.869 -4.13123 -2.00049 -3077 4 27.8882 8.69791 39.5144 34.8971 -1.31486 9.68376 -3078 6 0.711352 18.2475 15.2828 -1.03732 14.0577 26.4962 -3079 4 1.6037 18.2498 14.9622 18.0256 -6.96047 -13.9963 -3080 4 0.201613 17.7329 14.6701 -10.6254 -13.4061 -11.9404 -3081 6 7.11345 16.2289 40.4432 8.45023 -35.9074 47.1296 -3082 4 7.17312 15.3057 40.7986 -0.221024 11.0765 -27.8146 -3083 4 7.22051 16.6703 41.3088 -5.23596 22.4775 -22.5048 -3084 6 41.0858 8.62552 20.9048 11.0684 -11.3616 26.0286 -3085 4 40.3918 8.42716 20.2762 -10.0062 9.73992 -12.3328 -3086 4 41.3944 9.53753 20.8124 -4.81268 6.06535 -10.7329 -3087 6 31.7073 7.42286 37.542 -14.8479 -9.90339 6.69006 -3088 4 31.4959 7.12404 36.6506 2.47263 0.526998 -6.01676 -3089 4 30.9335 7.11441 38.0458 14.4773 7.59586 -0.291785 -3090 6 40.7266 11.6476 25.425 -35.4896 13.4329 -16.1803 -3091 4 40.7395 12.5913 25.6925 9.9362 -18.5419 -7.18222 -3092 4 41.5423 11.2236 25.6435 22.7694 -4.71413 12.394 -3093 6 29.8665 30.1579 6.66307 26.6562 -4.16721 8.5177 -3094 4 30.5555 30.7343 6.31583 -2.18777 1.73834 -10.5199 -3095 4 30.3573 29.3259 6.76714 -13.2281 -1.59651 -6.45815 -3096 6 40.8439 24.5837 5.68012 15.8615 33.1962 -4.14396 -3097 4 41.3457 25.4223 5.9023 -8.27611 -29.5734 -8.52614 -3098 4 40.1119 24.5659 6.27901 -12.3156 -1.80355 11.8721 -3099 6 34.3917 9.09675 20.4219 17.6262 -1.15942 17.9162 -3100 4 33.57 9.43601 20.7884 -5.86563 4.88571 -3.34935 -3101 4 34.2167 8.80099 19.5352 -13.2656 -6.03918 -15.2606 -3102 6 18.2311 33.5548 26.5354 9.60899 -55.578 -54.4315 -3103 4 19.159 33.2107 26.4405 -23.3884 24.4218 8.45675 -3104 4 18.1621 34.044 27.3085 3.33799 34.4716 53.9641 -3105 6 28.9072 17.4193 26.7965 8.90265 -1.34032 10.3526 -3106 4 28.3267 16.8801 26.2506 -9.53448 5.67773 -5.57268 -3107 4 28.3756 17.7646 27.5432 9.63981 -8.23286 -8.72686 -3108 6 50.4255 35.5446 18.192 14.112 9.6817 -2.74072 -3109 4 50.5661 35.3326 17.2487 -8.6314 -7.47676 15.7559 -3110 4 50.5766 34.7477 18.7329 -11.9848 3.75846 -10.2286 -3111 6 2.99463 21.5653 31.4474 1.68271 -21.0005 -22.757 -3112 4 3.33698 22.262 30.8385 -11.1525 -11.1618 12.076 -3113 4 2.83901 20.7479 30.8788 5.9339 29.1288 19.4027 -3114 6 36.1811 18.7457 8.60665 26.0746 50.7707 2.54435 -3115 4 36.1969 17.9289 9.04749 -6.79937 -48.2248 12.3681 -3116 4 35.6147 18.7828 7.85483 -18.853 -7.00319 -22.0811 -3117 6 20.2934 6.48366 33.7248 -33.7925 -21.1439 9.08779 -3118 4 19.8228 6.33509 34.5702 11.9648 11.0481 1.53323 -3119 4 19.9109 5.73333 33.234 17.8653 6.32962 -8.93867 -3120 6 14.0016 30.5326 6.65439 -2.06342 0.226434 14.1624 -3121 4 14.6658 31.0189 7.18657 -8.4774 -5.82658 -13.2159 -3122 4 13.1556 30.6664 7.11082 5.19683 1.19435 -6.65694 -3123 6 36.2738 16.4523 35.7634 28.7444 28.7466 -1.25628 -3124 4 37.2529 16.3082 35.8444 -30.8138 -2.80693 3.80535 -3125 4 36.1869 17.4417 35.6433 -1.25715 -33.4762 0.326736 -3126 6 45.8255 37.6646 9.68707 16.0609 -41.2042 -13.6418 -3127 4 45.4852 38.2919 10.2717 -20.4348 34.8513 25.7777 -3128 4 46.231 37.0083 10.2774 7.06244 2.74597 -12.4723 -3129 6 47.4229 17.9968 27.6368 -1.79372 -57.0164 -4.60636 -3130 4 47.566 17.432 26.8065 -4.8869 24.4286 27.8294 -3131 4 47.3631 17.3546 28.4089 6.87022 22.2846 -25.0829 -3132 6 25.9574 18.2976 0.964228 23.0858 -4.77958 -10.3735 -3133 4 26.3734 18.9022 1.60725 -19.9671 -4.02324 -2.33442 -3134 4 24.9961 18.2982 0.948557 -9.32218 6.60301 10.8105 -3135 6 27.3657 22.4026 4.28337 1.04907 -15.9856 -17.2206 -3136 4 27.2658 23.3197 4.47064 2.83879 26.7243 10.1579 -3137 4 27.3462 22.4079 3.3181 -1.05974 -10.8362 7.50108 -3138 6 3.39902 3.84297 27.6033 -32.797 -16.937 8.3321 -3139 4 3.87422 4.64571 27.4715 26.6916 15.5682 -1.1402 -3140 4 3.96055 3.06079 27.6076 7.92228 2.5358 -5.38712 -3141 6 45.3564 27.6573 28.835 13.8657 -6.64535 19.4164 -3142 4 44.592 27.1099 28.6295 -10.1072 2.65107 -0.516215 -3143 4 45.3903 28.3299 28.161 -2.22034 5.33578 -9.67936 -3144 6 28.3928 32.384 16.2149 35.1766 -7.36337 1.61596 -3145 4 29.2284 32.2059 15.7054 -23.0821 5.0916 11.0276 -3146 4 28.7076 32.6186 17.1078 -8.03404 1.42552 -9.59962 -3147 6 9.90485 33.8293 13.0286 10.5996 -3.42126 36.647 -3148 4 9.63365 33.2371 13.7754 2.50037 15.8816 -14.8106 -3149 4 9.32864 33.6931 12.2897 -16.1444 -6.90665 -19.0975 -3150 6 38.3335 26.6343 14.9205 -0.551684 -24.4487 3.86314 -3151 4 38.658 25.7334 15.149 1.53578 20.736 -5.06851 -3152 4 37.3858 26.5974 15.0972 1.00556 4.30146 -0.183996 -3153 6 31.3571 16.3836 4.2445 -16.7299 -18.7641 16.8138 -3154 4 30.5501 15.9079 4.56795 14.9054 8.61271 -6.80276 -3155 4 31.2311 16.4593 3.29715 -1.72501 9.16645 -9.12782 -3156 6 6.17482 3.39637 6.55833 17.6941 29.4886 56.031 -3157 4 6.41103 3.08651 7.49149 -7.06328 10.7723 -41.2395 -3158 4 5.9143 2.63963 6.07247 -2.51266 -29.5732 -15.1374 -3159 6 42.5954 13 5.61529 2.6815 -10.2341 6.00586 -3160 4 42.2228 13.83 5.89445 -1.70762 9.74234 -1.3058 -3161 4 43.4476 12.9425 6.06763 3.18432 -3.38396 -9.63491 -3162 6 41.0469 31.4032 33.8032 -2.41258 31.7421 -2.74763 -3163 4 40.7074 31.3974 34.7214 7.44932 1.1292 -16.4995 -3164 4 41.1575 32.3688 33.5162 -1.31614 -41.8694 16.6901 -3165 6 52.8576 12.0626 26.2641 9.5895 -24.4248 -55.9842 -3166 4 52.4684 12.727 26.7939 -19.7064 26.0739 18.5009 -3167 4 52.6066 12.2568 25.3043 12.3637 -4.77707 33.6793 -3168 6 39.2086 4.29542 29.0724 8.4008 5.1904 -7.5125 -3169 4 38.4444 4.85752 29.2861 11.0986 -5.7068 1.32154 -3170 4 39.9986 4.64958 29.5231 -9.05665 -5.78587 -2.57989 -3171 6 3.65769 27.0104 11.285 -33.2394 -3.70913 -3.8751 -3172 4 4.59992 26.8829 11.3514 17.6792 2.33561 -5.11125 -3173 4 3.4519 27.7953 10.7423 10.2361 0.60791 3.91121 -3174 6 41.5441 29.6402 25.2654 2.79284 -4.6021 22.0238 -3175 4 41.8464 29.7038 24.3667 4.04268 2.71218 -16.2057 -3176 4 40.7127 30.1073 25.3399 -6.11251 5.69311 -9.79107 -3177 6 50.4754 27.4974 30.671 -6.87832 -12.1873 7.27551 -3178 4 50.0778 27.1279 31.4799 3.22248 2.82006 -4.01445 -3179 4 49.7824 27.9982 30.2275 0.0461655 4.73 -3.38362 -3180 6 32.7876 33.6322 41.7537 -8.7541 -8.89692 -39.0089 -3181 4 33.1671 32.7559 41.8028 5.47994 -11.5785 5.15438 -3182 4 32.9083 34.029 0.675063 4.83491 15.974 33.6037 -3183 6 5.9806 9.64323 7.93715 4.3965 6.41539 -15.2951 -3184 4 5.77829 9.93579 8.8312 0.6559 3.73469 4.68299 -3185 4 6.3228 10.4083 7.4265 1.56495 -8.59939 9.02132 -3186 6 52.7884 25.3949 27.7 -7.43266 -9.74322 -1.44878 -3187 4 52.93 26.351 27.8747 -0.851616 -24.8244 8.41831 -3188 4 52.9998 24.8518 28.4994 7.3809 16.2458 -18.9874 -3189 6 18.6796 23.2043 14.4609 8.49541 46.7244 28.1607 -3190 4 18.697 24.1166 14.872 -21.1178 -26.825 -16.729 -3191 4 19.5981 23.1771 14.2416 15.365 -21.3066 -15.3625 -3192 6 31.2857 9.07887 13.0786 26.2489 -54.2202 -11.3888 -3193 4 31.3193 8.20519 13.5416 -2.63874 16.5358 -10.154 -3194 4 30.7972 9.64602 13.6278 -24.9284 29.9413 31.6235 -3195 6 52.8163 16.833 29.9704 25.4684 -2.46115 -18.7711 -3196 4 53.1785 16.3479 29.2052 -11.8989 0.938692 6.7974 -3197 4 53.5445 17.4528 30.1342 -3.36222 3.81908 9.3955 -3198 6 13.4835 30.6533 11.9137 -46.9609 -12.8402 15.0292 -3199 4 12.8701 31.2475 12.4314 22.3442 -12.341 -15.3642 -3200 4 14.3315 31.0589 11.9363 20.4041 22.2607 2.0467 -3201 6 24.4145 24.6647 11.1793 -22.2983 -41.6602 -10.5575 -3202 4 25.2113 25.1208 11.3859 27.2622 9.38308 11.5927 -3203 4 24.6402 23.6908 11.0915 -11.4513 27.6962 10.6476 -3204 6 11.1203 26.798 5.92715 -0.288466 28.8994 -0.991584 -3205 4 11.4516 26.991 6.8143 4.21529 -7.59652 -0.673238 -3206 4 11.0194 27.7223 5.58288 -7.6649 -30.4822 0.0195949 -3207 6 12.0071 32.3096 4.57291 -4.86243 14.2275 -68.6847 -3208 4 11.7793 31.9281 3.63093 8.01684 14.4954 56.5286 -3209 4 12.2995 33.2463 4.37904 -4.11207 -26.5611 6.70158 -3210 6 6.4322 5.49281 30.4716 35.2368 -18.2726 5.22228 -3211 4 6.85856 6.3256 30.2181 -6.14256 4.86399 -3.96588 -3212 4 5.49729 5.53619 30.4137 -26.8093 16.306 -3.74387 -3213 6 38.1866 39.6 29.3849 -55.2477 -18.0227 -31.7741 -3214 4 37.4363 40.1798 29.0864 28.3626 1.3397 12.8196 -3215 4 37.8398 38.7214 29.0428 28.3274 26.4583 13.0641 -3216 6 52.5811 19.3636 5.41604 51.907 48.1011 -36.5249 -3217 4 52.4834 20.3242 5.17263 -20.1975 -32.0404 8.71389 -3218 4 53.4908 19.2453 4.99747 -31.6145 -20.6418 25.5541 -3219 6 18.3356 9.8205 21.0747 -17.6268 -29.6196 -17.636 -3220 4 17.8021 9.40634 20.3533 -1.88913 9.35392 27.897 -3221 4 19.0546 10.1733 20.5835 25.9839 20.5094 -7.72749 -3222 6 14.4924 41.1161 15.0432 10.1364 3.71296 -9.89663 -3223 4 15.2732 41.1462 15.6022 9.62288 -5.62086 4.10329 -3224 4 13.9031 41.7078 15.5102 -8.32301 1.75038 3.32266 -3225 6 35.9996 23.9069 26.7492 18.6837 -25.8156 -39.8793 -3226 4 35.9246 23.4421 27.5469 -8.45021 -0.659318 44.9575 -3227 4 36.3072 23.1381 26.2025 -8.08285 36.2837 5.17172 -3228 6 35.634 10.4286 26.2543 -16.0886 -36.8378 31.8954 -3229 4 36.0318 10.4196 25.4062 11.0324 6.64788 -31.8122 -3230 4 35.4344 9.46932 26.4326 4.10196 23.0818 -6.20158 -3231 6 45.3004 24.2842 20.2749 24.2383 10.4641 7.4623 -3232 4 45.3515 25.0535 19.6808 2.20237 -7.91345 -3.22769 -3233 4 44.5434 23.7522 20.0895 -20.4117 -5.11737 -13.922 -3234 6 15.8182 39.0515 24.2407 12.965 16.6456 0.954929 -3235 4 15.3741 39.8779 24.5544 7.5658 -17.411 -0.0196462 -3236 4 16.7724 39.3066 24.1247 -29.8541 -4.22386 6.92178 -3237 6 4.60659 25.9073 16.8122 1.83212 2.60998 -1.97709 -3238 4 5.31562 26.4095 17.2499 -5.00617 -6.2898 0.278133 -3239 4 3.79975 26.4302 16.9186 11.5163 2.87992 -0.585475 -3240 6 33.4767 9.9887 32.5701 -44.5277 -5.18869 -27.5725 -3241 4 34.322 10.1593 32.8843 54.6618 16.656 18.5178 -3242 4 33.0203 9.70843 33.3575 -8.70161 -12.0001 8.14623 -3243 6 22.9321 37.514 1.50284 -0.19108 -28.0604 17.8877 -3244 4 23.0149 38.2279 2.13297 1.92014 9.99004 7.14626 -3245 4 22.7552 36.7067 2.06858 1.19451 21.8657 -20.5647 -3246 6 39.1248 20.5474 25.4766 21.2332 -16.8391 26.0428 -3247 4 39.2186 21.3943 25.0643 2.22233 17.645 -5.02625 -3248 4 39.853 20.5019 26.1611 -16.83 0.667515 -19.8449 -3249 6 25.0699 25.071 37.6104 17.3941 16.9986 -26.7924 -3250 4 25.9994 25.4036 37.6322 -19.4928 -16.3283 1.07636 -3251 4 24.8822 24.8366 38.5108 -1.54859 -5.98321 18.8059 -3252 6 12.2108 35.7702 11.4211 -21.274 -0.450661 -24.3109 -3253 4 11.4942 36.1177 10.8268 17.2098 -2.57945 23.3101 -3254 4 12.7534 35.3113 10.7723 8.20233 4.40137 5.7707 -3255 6 42.0318 15.7212 20.1319 23.9789 -4.66934 -19.8056 -3256 4 42.573 15.4482 19.3354 -11.2719 11.6022 18.1956 -3257 4 42.3198 16.6222 20.3614 3.24172 -2.08619 -3.65764 -3258 6 53.203 25.4276 39.527 3.00787 -13.9161 6.63788 -3259 4 53.7641 25.8569 38.8977 9.18601 6.10619 -8.92001 -3260 4 52.4886 26.0297 39.6953 -12.4398 9.9207 3.51955 -3261 6 53.7999 21.7704 1.29423 13.4333 -6.07506 22.1965 -3262 4 54.6908 21.5389 0.969279 -9.57261 -3.1085 -1.99035 -3263 4 53.3016 22.2177 0.619486 -6.56312 6.61298 -22.2093 -3264 6 1.93757 22.4543 20.1748 -8.22485 -1.41006 19.3874 -3265 4 1.60089 23.2534 20.6505 8.04613 -19.7643 -7.74833 -3266 4 2.27012 21.8339 20.8623 2.42307 18.0741 -7.93574 -3267 6 41.1802 16.179 11.484 -8.24259 53.7733 14.6683 -3268 4 40.8475 15.3772 11.8508 -2.32532 -30.9762 7.10209 -3269 4 40.6167 16.8825 11.9353 16.6943 -22.3779 -21.294 -3270 6 17.1967 38.6113 9.60334 5.35995 -1.86267 -8.12923 -3271 4 17.7852 38.6361 10.3521 13.641 -0.452934 12.0217 -3272 4 16.3282 38.6029 9.98982 -18.6262 -0.708432 10.1602 -3273 6 33.1969 12.9538 38.5484 12.352 25.5713 -8.86638 -3274 4 33.6486 13.824 38.4674 -8.05485 -18.2555 -5.8969 -3275 4 33.0335 12.8861 39.4897 4.37007 -7.66636 -4.23751 -3276 6 24.7228 21.6957 39.9776 0.331302 -26.4697 -8.75647 -3277 4 24.5832 21.6143 39.0045 0.235774 0.581704 12.5709 -3278 4 25.2663 20.9218 40.2505 -4.0265 10.6546 -4.86064 -3279 6 13.577 15.5497 27.3411 27.7809 44.9786 27.5516 -3280 4 13.196 16.0821 28.0648 5.30872 -0.0493108 -10.0398 -3281 4 12.9031 14.935 27.2057 -29.8548 -39.4113 -11.0219 -3282 6 24.6863 18.7248 9.26482 -8.80414 -2.51529 14.0236 -3283 4 25.3563 19.2311 8.7609 -6.6335 -0.338001 12.1858 -3284 4 24.3761 19.0911 10.1338 17.243 1.91927 -22.7003 -3285 6 10.9743 8.21046 0.042398 -18.7759 13.8117 62.0104 -3286 4 10.3469 8.74796 0.639501 28.6352 -16.9877 -21.8389 -3287 4 11.7753 8.08291 0.592641 -4.28958 7.52309 -10.9298 -3288 6 15.7499 31.9609 31.3743 -17.6212 -20.5964 15.467 -3289 4 14.8817 31.9157 30.9761 -10.6343 5.00824 -7.09118 -3290 4 16.0827 32.8403 31.1978 10.1106 0.369155 -2.88897 -3291 6 20.3726 39.1695 21.6147 20.5981 -29.5513 41.0934 -3292 4 19.9726 38.3531 21.9994 -5.82675 23.323 -22.8284 -3293 4 21.1172 39.24 22.2595 -11.0324 14.4144 -20.0969 -3294 6 38.8594 19.5251 7.6091 -6.47304 13.0289 -25.1371 -3295 4 38.0017 19.0955 7.57416 -1.20877 -0.517864 1.64758 -3296 4 39.1744 19.3685 8.48411 8.18586 -10.9486 17.219 -3297 6 41.3695 29.7301 21.1465 -57.7285 -14.4296 34.1578 -3298 4 41.7832 29.6286 20.3251 24.9116 3.74799 -36.1007 -3299 4 41.9865 29.9579 21.8177 26.2541 9.18996 12.3917 -3300 6 50.7039 33.8333 22.0593 7.50244 -20.9835 17.6314 -3301 4 50.9654 32.9474 22.4123 -1.20949 24.7473 -8.4765 -3302 4 50.362 33.6446 21.1779 1.66119 1.27804 -3.63001 -3303 6 18.1671 11.1714 14.3658 -12.4278 -6.78987 13.7569 -3304 4 18.0724 11.2679 15.338 -0.312443 2.59996 -20.4321 -3305 4 19.115 11.0923 14.227 4.83391 -0.924272 -3.79066 -3306 6 48.5058 14.2689 15.2513 -36.7782 -21.7282 -18.3567 -3307 4 49.3677 14.5693 15.4148 44.1026 10.3807 8.68918 -3308 4 48.5803 13.5893 14.5426 -8.44167 10.5166 12.8885 -3309 6 32.9801 15.74 8.25484 19.5805 1.81858 6.30948 -3310 4 33.8151 15.5666 7.78828 -7.72407 0.576521 2.61047 -3311 4 33.2057 15.7253 9.21147 -5.47651 1.26655 -15.0149 -3312 6 42.9141 4.85593 18.7596 35.6338 16.8786 18.3104 -3313 4 43.0674 5.82698 18.891 -14.0493 -22.2454 -3.89051 -3314 4 43.7794 4.50634 19.0974 -23.5505 0.71427 -17.3058 -3315 6 10.488 23.7131 33.4436 27.6073 45.1219 -14.7699 -3316 4 10.638 24.6985 33.3892 -15.3766 -28.1208 6.63949 -3317 4 11.1638 23.4099 32.8243 -6.46894 -14.1785 5.09081 -3318 6 1.12582 20.0662 11.2775 2.81918 8.09367 56.8435 -3319 4 0.488344 19.3589 11.407 -2.14544 -6.99577 -20.9797 -3320 4 1.17571 20.424 12.22 2.69463 -2.11621 -44.733 -3321 6 1.50824 39.5346 14.3079 -5.25271 -28.0543 15.9462 -3322 4 0.868346 40.1487 14.6984 3.61457 -0.641003 -8.28938 -3323 4 1.2571 38.629 14.6571 12.5115 33.2201 -10.0417 -3324 6 8.3332 21.6069 14.1357 -16.8636 -16.8509 36.8071 -3325 4 8.17334 21.0976 14.9962 5.25323 23.3985 -29.627 -3326 4 7.56323 21.4407 13.5807 -3.95337 3.79773 -2.56685 -3327 6 7.16177 13.3249 38.2255 -6.34169 -18.8056 -1.32195 -3328 4 6.69256 13.0329 37.4043 9.76156 12.0715 20.3406 -3329 4 7.43529 14.2522 38.1581 -0.0118119 -11.8895 -14.491 -3330 6 46.6212 1.64167 18.6867 -0.0463537 -24.1078 41.7639 -3331 4 47.541 1.5611 18.992 -0.862753 9.16913 -10.8716 -3332 4 46.1606 1.36736 19.5239 4.43612 14.9978 -24.7224 -3333 6 4.08147 8.39338 14.788 26.1694 13.8207 2.32184 -3334 4 3.41636 8.28931 15.4347 -29.1417 0.0985708 23.0338 -3335 4 3.90156 7.69349 14.1818 -2.47935 -14.3959 -27.3016 -3336 6 47.5712 36.5372 17.8422 14.6219 44.3363 14.3039 -3337 4 47.1691 35.7037 17.6938 -6.70251 -40.3849 -9.96305 -3338 4 48.5299 36.4434 17.8412 5.708 -14.7801 -1.83759 -3339 6 48.7177 32.6293 3.61477 24.5557 -7.82504 -30.2396 -3340 4 49.3183 32.0587 3.09719 0.221751 18.4164 7.83871 -3341 4 48.4066 32.0299 4.25286 -21.3126 -17.4552 36.5328 -3342 6 26.8672 34.4113 15.184 7.18591 -12.831 -4.85448 -3343 4 27.1806 33.7337 15.7866 -5.2278 -3.11582 5.08403 -3344 4 27.3382 34.1395 14.3734 -5.71629 20.1707 6.74573 -3345 6 9.99603 27.3398 13.3337 -11.5184 -70.0362 -20.4383 -3346 4 9.96963 28.1856 12.9595 -3.0362 48.3298 -16.8459 -3347 4 9.789 26.7159 12.5598 12.8825 26.2078 29.4693 -3348 6 2.39106 26.8936 37.3456 -18.0299 -5.48602 7.48259 -3349 4 2.24944 26.7597 38.2955 12.6258 0.126767 -1.18485 -3350 4 3.33209 26.9598 37.1993 18.2818 -0.192027 1.55797 -3351 6 33.3384 17.273 36.7956 -4.69576 6.00605 30.6641 -3352 4 32.3777 17.4022 36.9421 6.35755 -1.66054 -12.3647 -3353 4 33.5147 17.1107 35.8745 -6.55426 -0.461729 -19.8283 -3354 6 10.6704 18.7989 9.29568 -2.62714 4.796 -4.28658 -3355 4 10.7729 18.8103 8.31395 -3.57004 -0.312677 18.1362 -3356 4 10.9356 19.679 9.6198 -4.15772 -1.10699 -11.1079 -3357 6 8.58029 27.4085 3.13543 -0.646896 -38.9365 14.7517 -3358 4 8.62134 27.4642 4.10772 -2.35878 18.0768 -8.00568 -3359 4 8.54298 26.4189 3.06204 -3.80038 30.3142 -4.62402 -3360 6 40.6121 33.9148 14.3433 -13.4775 28.2536 -12.7531 -3361 4 40.8898 33.2957 14.9932 8.13038 -23.145 12.8628 -3362 4 40.1237 34.5547 14.8716 -1.64981 1.12342 -7.13376 -3363 6 54.0126 16.7742 13.6402 -25.2384 12.1291 10.4483 -3364 4 54.0311 17.2666 12.8352 12.7766 5.78776 -30.0788 -3365 4 53.1083 16.9555 13.9311 3.38038 0.740926 17.4694 -3366 6 39.1613 38.4947 7.40674 -49.2832 -1.36929 38.9537 -3367 4 38.8094 38.4839 6.52049 1.87105 5.40513 -14.0728 -3368 4 38.3203 38.5292 7.99504 41.7155 2.10662 -28.5328 -3369 6 42.2152 33.6749 29.0207 -49.4578 14.7313 -27.4402 -3370 4 42.0113 34.6279 28.8262 15.7605 -21.0767 3.4048 -3371 4 41.3749 33.2313 28.6743 34.021 9.03137 24.2205 -3372 6 2.84529 0.06018 20.1342 1.75144 -0.125494 -5.27144 -3373 4 2.85876 0.453048 19.2323 -10.3946 -7.40064 8.89792 -3374 4 1.95714 41.5787 20.3005 13.5701 9.63706 -6.70109 -3375 6 24.9846 26.9367 24.435 4.97654 17.1262 30.4362 -3376 4 25.3707 26.0628 24.5275 -2.48626 -13.7157 -10.817 -3377 4 25.1946 27.3852 25.2847 -1.69157 -3.92554 -20.3381 -3378 6 13.6202 33.989 7.00835 -29.3159 10.7937 -13.6787 -3379 4 14.4707 33.6317 6.76766 5.19255 -3.31821 -12.8703 -3380 4 13.1262 34.2356 6.16936 24.7045 -4.21039 25.9053 -3381 6 17.6361 31.8361 3.38698 11.6752 63.8731 -26.646 -3382 4 17.3765 32.06 2.46015 3.81419 -8.12146 27.658 -3383 4 17.5414 30.922 3.45915 -17.4061 -53.1647 5.72422 -3384 6 31.114 29.8463 35.9142 20.4735 12.0385 -23.871 -3385 4 30.4046 29.6578 36.4892 -25.9224 -10.1565 23.4082 -3386 4 31.8798 29.3863 36.2596 4.49336 -0.641295 3.24883 -3387 6 31.4544 1.69927 1.93203 61.0942 61.1307 23.4408 -3388 4 30.847 1.03155 1.81447 -56.5376 -48.8621 -2.33617 -3389 4 31.1234 2.33851 2.60628 -4.67927 -17.7811 -18.4359 -3390 6 13.7206 9.35179 12.308 -20.4886 -14.5553 22.3614 -3391 4 13.8994 10.2254 12.0406 16.2488 33.284 -13.5816 -3392 4 13.1923 9.47724 13.1212 6.47756 -14.062 -7.29461 -3393 6 15.2915 15.1706 12.1407 -39.3514 -20.6771 -15.8676 -3394 4 14.288 15.1355 12.0691 34.6095 3.19954 13.2467 -3395 4 15.5721 14.5705 11.433 2.70369 1.94224 0.817449 -3396 6 44.9298 30.4448 13.0945 -83.0621 -13.8007 20.4391 -3397 4 45.2326 30.6692 13.9612 22.7288 5.76966 14.7184 -3398 4 45.5619 30.4921 12.4362 58.1466 4.79773 -38.6719 -3399 6 35.1494 37.6283 24.8564 -28.9971 -18.9514 34.2227 -3400 4 34.5453 38.351 25.1691 15.7809 -12.2194 -9.31628 -3401 4 34.8969 36.8477 25.46 15.2444 28.3361 -22.0595 -3402 6 43.9018 19.2999 12.9893 -4.23684 -28.8047 14.7243 -3403 4 43.7111 18.3276 12.9437 8.07938 21.0179 -2.3859 -3404 4 44.434 19.3703 13.8064 -8.2748 4.27416 -6.23054 -3405 6 14.1928 27.3824 16.8974 17.9721 24.801 -15.5057 -3406 4 13.3941 26.8971 17.049 -12.9837 -13.2841 -1.45311 -3407 4 14.075 27.8458 16.0392 0.928992 -14.2323 10.6565 -3408 6 5.07867 37.4759 15.7278 -19.2695 5.34987 61.0101 -3409 4 5.83402 37.4907 16.3496 5.41141 -1.20808 -8.02024 -3410 4 5.40595 37.3511 14.8725 27.2981 -13.142 -45.6678 -3411 6 35.4792 36.9736 33.2279 -33.1303 3.22524 14.2013 -3412 4 36.4062 37.0387 33.1707 43.394 6.70104 -6.41693 -3413 4 35.2647 37.5361 33.9926 -10.1497 -5.08286 -5.32556 -3414 6 6.63713 31.7122 32.9951 -15.6769 -13.4095 -29.903 -3415 4 7.30356 31.0631 32.7808 0.413821 -11.0386 -1.85208 -3416 4 7.01801 32.1732 33.7097 9.96672 21.2943 24.541 -3417 6 31.2686 20.2272 25.4717 1.63607 -11.2998 14.888 -3418 4 30.457 20.1188 26.0175 18.7046 8.55246 -6.40474 -3419 4 30.9671 20.3507 24.5747 -9.02709 8.2981 -6.80006 -3420 6 54.9594 26.0897 7.3541 -26.2324 -3.52234 4.1817 -3421 4 54.3149 26.536 6.76189 8.45344 -4.14623 9.81761 -3422 4 54.4064 25.6921 8.06559 9.60693 6.10548 -13.0393 -3423 6 17.8786 35.1581 24.3912 -48.4608 -31.2574 -23.2844 -3424 4 17.9034 34.576 25.1672 15.4891 12.513 -1.90366 -3425 4 17.14 34.695 23.8716 34.0055 23.8611 10.1154 -3426 6 49.1404 3.30993 19.753 -11.7437 -5.45724 -22.9314 -3427 4 48.7379 4.07245 20.162 -0.785462 12.6857 6.5087 -3428 4 49.8408 3.03849 20.3377 4.84054 -6.57183 8.59361 -3429 6 30.2791 35.6014 13.4902 -0.275976 1.62471 9.45881 -3430 4 29.4038 35.7322 13.1068 5.01216 -3.78726 -8.18413 -3431 4 30.1007 35.4484 14.4302 1.26073 -0.50544 -4.60872 -3432 6 43.3857 25.8788 41.6729 -28.3599 -13.2186 -4.43344 -3433 4 44.0236 25.6058 41.0289 13.0372 -2.28568 -15.7328 -3434 4 43.8192 26.4334 0.378509 18.4346 21.3926 23.5205 -3435 6 21.1033 23.1572 6.40534 -12.8895 6.60285 13.2505 -3436 4 21.2833 23.9599 6.94372 3.68538 -20.4677 -7.26612 -3437 4 21.2354 23.4378 5.50624 8.61756 6.39287 -19.4039 -3438 6 54.6209 21.1977 19.0953 -9.4905 16.5472 15.3455 -3439 4 0.355231 21.543 19.6762 -10.082 -5.94448 -19.8865 -3440 4 53.803 21.6498 19.4211 22.178 -8.62035 -3.94206 -3441 6 13.8696 38.9444 18.7589 -0.408574 -9.95072 10.686 -3442 4 13.5473 38.5195 19.5701 -4.79749 -3.34053 -10.6661 -3443 4 14.2783 39.7511 19.0654 -4.68159 17.5572 -2.41189 -3444 6 39.1837 2.73799 39.6933 -2.22487 -14.248 -19.2211 -3445 4 38.5048 2.18054 40.1045 3.50502 9.25929 9.72195 -3446 4 39.1752 2.3966 38.7788 -3.09486 7.3066 6.14055 -3447 6 43.2236 33.8218 8.83748 -23.7799 54.6507 -8.87946 -3448 4 43.1776 32.9835 9.22653 -2.14792 -45.6212 21.4927 -3449 4 42.4318 34.327 9.18683 27.5752 -12.6709 -4.85681 -3450 6 23.0768 16.6786 12.1043 19.2201 -8.5648 -22.0864 -3451 4 23.4688 16.2415 11.3109 -7.42341 7.06352 19.0042 -3452 4 22.1329 16.714 11.9048 -3.02708 6.60369 6.72608 -3453 6 40.7875 26.1445 36.3165 -31.0446 26.1707 15.63 -3454 4 40.1182 26.8831 36.2336 22.2291 -27.8038 4.66075 -3455 4 41.0346 25.9172 35.4285 12.0382 -0.567557 -16.236 -3456 6 15.1503 11.6728 19.298 -10.8743 -20.3409 15.6657 -3457 4 15.4707 12.2619 18.6272 13.0208 17.9076 -10.0848 -3458 4 15.518 11.9699 20.1418 -0.780585 5.28883 -4.88637 -3459 6 9.8485 29.8084 31.3808 31.6725 31.0987 -15.032 -3460 4 10.6075 30.172 31.8684 -9.75043 -12.6573 12.7307 -3461 4 9.98584 30.2945 30.5336 -20.1344 -22.7331 8.89086 -3462 6 2.12557 30.0341 25.264 -3.96851 -24.8252 -11.595 -3463 4 2.04755 29.1979 25.7442 2.8488 12.5065 4.07713 -3464 4 2.06741 29.7398 24.3306 5.27272 21.1251 20.17 -3465 6 49.0124 10.6515 7.04668 12.8278 -6.79775 19.6819 -3466 4 49.7765 10.456 7.62014 -4.12072 9.88663 -9.32692 -3467 4 48.4954 9.84699 7.16976 -12.5497 -3.43755 -7.74842 -3468 6 38.6385 34.4247 32.4851 8.7415 15.3068 2.26745 -3469 4 38.2449 35.2411 32.8392 7.79483 -2.42751 -9.0272 -3470 4 38.3877 33.7513 33.1114 -5.41613 -8.85245 5.88093 -3471 6 24.2967 24.7175 4.7858 -13.8074 20.2372 -8.25903 -3472 4 24.5879 23.8747 5.12331 8.49271 -10.4438 10.0312 -3473 4 24.0688 25.3355 5.52385 7.10746 -21.4288 -14.6014 -3474 6 44.0211 23.587 33.7713 -18.8641 -18.6234 -6.9532 -3475 4 43.6265 23.0569 33.047 -3.30007 6.44469 22.3225 -3476 4 44.7839 23.9213 33.3479 32.8249 22.1868 -7.88886 -3477 6 45.135 31.9539 26.6318 17.8742 -16.5206 -32.2352 -3478 4 44.6965 32.0125 27.458 -12.8805 4.46476 28.7394 -3479 4 45.0195 31.023 26.337 -1.34861 17.8758 10.4404 -3480 6 52.0545 6.36303 22.865 -1.87051 -30.929 -4.90791 -3481 4 51.4549 5.58836 23.0553 13.7734 29.2588 0.606927 -3482 4 51.4955 7.14596 22.8951 -3.5837 -3.73437 -5.39564 -3483 6 5.1124 17.7016 30.4663 -17.3022 -2.39818 -4.94531 -3484 4 5.57517 17.705 29.6436 5.33167 -14.42 -26.4334 -3485 4 5.6774 18.2653 30.9495 12.7188 16.8745 32.2475 -3486 6 48.5399 17.0091 6.52669 31.3107 25.6813 -22.3666 -3487 4 48.2466 16.108 6.56632 -4.44525 -18.5722 0.0807757 -3488 4 49.3123 17.0767 5.87973 -32.0368 -4.22047 21.2267 -3489 6 13.8017 31.3286 23.4652 -45.3568 -0.340859 23.461 -3490 4 14.0246 31.2001 24.3905 13.6426 -1.74144 -0.768444 -3491 4 14.5269 31.1963 22.8948 44.8358 -8.96568 -14.3918 -3492 6 28.4984 33.4231 26.025 30.2115 45.129 -4.70205 -3493 4 28.7629 32.7421 25.4284 0.749934 -18.6264 -12.7861 -3494 4 27.7356 33.1626 26.4825 -33.9251 -20.2776 22.3239 -3495 6 9.04101 22.9533 11.0101 4.17271 5.63899 8.67886 -3496 4 9.24243 22.776 10.0879 9.05926 -1.29962 -0.957415 -3497 4 9.84172 22.774 11.5341 -6.79246 0.647577 -9.3095 -3498 6 40.5624 4.0706 26.5792 43.7479 -58.1273 15.512 -3499 4 40.0377 4.03321 27.356 -14.6911 0.39925 31.4188 -3500 4 40.1771 4.74143 26.1095 -33.6389 57.2603 -43.6855 -3501 6 17.0606 37.9689 20.9328 24.9068 -2.83666 19.2437 -3502 4 17.7492 37.7057 21.5806 -0.23423 0.332892 -22.3637 -3503 4 16.3 37.9671 21.4825 -28.3901 -0.1668 6.57955 -3504 6 31.9758 6.36253 14.1925 -47.1359 -2.961 8.2158 -3505 4 31.6652 5.47044 14.4516 -0.57512 5.53961 -9.89258 -3506 4 32.9075 6.27907 14.242 33.1863 -3.34593 -3.73058 -3507 6 29.3613 34.9484 39.6522 -7.7658 6.78361 -10.4711 -3508 4 29.4154 34.7255 40.5688 2.48129 -3.65799 19.6008 -3509 4 28.4079 35.1232 39.5563 9.75382 -5.50564 -9.65046 -3510 6 22.5642 2.93231 32.1024 7.89654 -13.571 4.24933 -3511 4 23.152 3.60479 31.7467 -0.797152 8.5773 -0.128413 -3512 4 22.8746 2.10235 31.6905 -8.86372 14.3523 0.842504 -3513 6 51.7365 19.0888 24.8036 24.4352 10.6631 34.2631 -3514 4 52.2011 19.3182 25.6664 -22.8444 -5.9403 -33.5217 -3515 4 52.2256 19.5376 24.1035 -3.13425 5.18677 -1.50107 -3516 6 32.1309 13.661 24.2221 8.32979 -1.22201 -48.3483 -3517 4 32.1718 13.7834 25.1379 3.34806 7.10631 53.6256 -3518 4 31.2192 13.5434 23.9915 -25.9097 -1.66347 2.1781 -3519 6 9.49478 30.1756 28.7975 -1.02802 7.68553 8.51386 -3520 4 8.9614 29.4447 28.4635 3.13242 -3.87437 -3.11369 -3521 4 9.76139 30.7024 28.0341 -4.99689 -6.39164 -2.13333 -3522 6 31.3017 3.1328 24.0821 -2.56057 -13.3126 7.41322 -3523 4 30.8642 3.97896 23.9468 1.03353 -0.10231 -3.56587 -3524 4 32.1597 3.13825 23.6386 1.18226 10.803 -0.447916 -3525 6 2.13915 19.8328 36.4477 43.9795 26.8161 3.66972 -3526 4 3.0929 19.9274 36.115 -41.9598 -16.8793 8.64164 -3527 4 1.76662 18.9777 36.2517 -5.24508 -9.86619 -11.2286 -3528 6 36.9558 16.7701 14.0992 8.10199 -24.1685 -1.60142 -3529 4 37.0878 17.1202 14.9938 -3.44507 3.84646 -3.58016 -3530 4 37.3137 15.854 14.1066 -5.27996 15.1268 -1.92478 -3531 6 1.82451 11.1811 6.08431 4.75441 9.84221 -14.5701 -3532 4 1.68522 10.3449 6.52934 -2.64515 -5.74712 4.44833 -3533 4 1.45572 11.848 6.66197 -6.16769 2.71123 7.45582 -3534 6 43.1467 36.8536 25.2684 -4.34259 -25.2275 5.76074 -3535 4 42.489 36.6679 24.5813 -1.65581 9.08703 8.09798 -3536 4 42.9757 36.1566 25.9418 7.67001 18.3814 -10.5814 -3537 6 32.1358 5.54258 7.00813 -0.159667 5.03525 -3.02009 -3538 4 31.8447 4.70695 7.37259 1.76357 -8.94122 3.22744 -3539 4 31.6184 6.21523 7.45425 -7.92944 5.35442 3.67752 -3540 6 15.0738 21.498 41.5176 2.48253 -6.99424 4.64434 -3541 4 14.4083 21.441 0.286083 -5.89506 -4.91034 13.0846 -3542 4 14.6326 22.02 40.8608 1.523 7.8898 -22.5967 -3543 6 37.0299 36.0573 5.68999 -1.26402 -4.33671 -4.68257 -3544 4 36.8992 36.8706 5.1864 -9.04185 9.38437 4.54051 -3545 4 36.6368 36.1345 6.57983 4.68584 5.64444 -6.17041 -3546 6 39.6378 22.8733 0.344261 -10.4835 1.90991 -1.04201 -3547 4 39.8967 23.7127 41.8596 6.32696 2.65577 1.7872 -3548 4 39.7641 22.9598 1.30287 2.84221 -4.68177 2.22816 -3549 6 18.471 23.1695 5.24444 18.17 13.8994 5.32385 -3550 4 18.2426 24.0888 5.07969 -12.1406 8.45165 -11.681 -3551 4 19.3434 23.2774 5.65727 -5.17221 -14.3673 2.51868 -3552 6 34.4951 26.4012 0.415196 -24.2262 -21.8504 23.5375 -3553 4 33.9567 27.1096 0.873351 15.2264 -25.8266 -5.88921 -3554 4 34.3584 25.5285 0.919462 6.17703 40.7497 -12.3351 -3555 6 28.1538 26.089 40.6186 -44.0465 -12.7539 23.8091 -3556 4 29.0676 25.9468 40.8623 9.74545 0.451611 8.45277 -3557 4 27.5517 25.6856 41.3354 31.2048 15.0133 -28.9196 -3558 6 41.7541 4.40312 30.2348 -21.1804 7.97019 15.7848 -3559 4 42.5951 3.9554 30.1474 10.5948 -6.90465 6.49815 -3560 4 41.6197 4.66064 31.1807 9.39609 -4.15263 -13.0838 -3561 6 4.45746 8.30422 29.123 17.0584 8.0822 12.8675 -3562 4 3.72424 8.78851 28.7689 -20.5564 0.917363 -10.5697 -3563 4 4.90241 9.00738 29.631 2.39094 -12.8625 -4.67793 -3564 6 12.9051 9.61174 32.1485 9.54391 19.7002 1.20842 -3565 4 12.5238 8.90328 31.6499 -4.6135 -18.7028 0.941221 -3566 4 13.4507 9.29961 32.8815 -5.77341 -6.01915 -0.606497 -3567 6 48.6524 16.2364 1.45279 -39.5117 19.3379 22.5337 -3568 4 49.5656 16.3395 1.57323 44.82 -2.42546 -4.76282 -3569 4 48.322 16.6449 2.29127 -2.06599 -18.2277 -23.678 -3570 6 26.4391 39.9942 21.1964 -5.73 55.7886 4.05886 -3571 4 27.1886 40.6225 21.0926 -13.7426 -7.13397 8.25982 -3572 4 26.7825 39.1793 20.9147 12.833 -38.7313 -7.54244 -3573 6 35.8074 4.09236 9.03492 -45.4698 -15.3304 -15.5709 -3574 4 35.5046 4.67089 8.30824 2.24043 1.80806 6.22839 -3575 4 34.9768 3.81452 9.52186 26.5657 10.3238 -8.47709 -3576 6 52.6895 3.55751 27.8666 50.2867 -19.9176 -34.5196 -3577 4 53.5586 3.5996 28.3549 -33.5645 -3.53647 -1.9565 -3578 4 53.0019 3.22463 26.9489 -24.4009 21.759 36.9675 -3579 6 48.3192 26.6913 27.3954 13.1896 -37.7442 -6.45526 -3580 4 48.9722 25.929 27.4853 -22.116 34.446 0.770506 -3581 4 48.7243 27.4862 27.7371 6.43066 9.80699 11.7315 -3582 6 24.507 4.96042 18.7259 -17.59 -10.4057 14.9036 -3583 4 24.0519 4.20246 19.1729 14.2279 16.3534 -10.8515 -3584 4 23.9406 5.7442 18.8517 8.31711 -9.56192 -0.149656 -3585 6 24.0493 12.473 28.7688 20.4432 11.2466 2.34496 -3586 4 23.2439 12.9627 28.9427 -11.3477 -3.77152 -2.6943 -3587 4 23.8404 11.6087 28.4204 -6.74951 -3.90152 -5.01594 -3588 6 40.1637 27.7353 40.8087 -33.5791 -9.4694 0.953173 -3589 4 40.5641 26.9832 41.236 1.78301 2.25495 0.260865 -3590 4 39.2218 27.4214 40.7917 21.7476 20.7917 -9.34619 -3591 6 11.9335 13.5538 26.9488 -1.21599 4.57236 -11.9259 -3592 4 11.0364 13.8177 27.1576 -7.67129 -6.9102 2.53909 -3593 4 12.2164 12.9501 27.6309 4.70555 -13.4351 6.55277 -3594 6 52.1924 29.5424 41.3942 11.5626 -24.8936 -19.0003 -3595 4 51.8104 30.1965 0.050158 4.44506 23.3375 14.6186 -3596 4 53.1351 29.3771 41.6391 -10.5303 1.44862 4.74126 -3597 6 17.4882 19.0285 39.1853 -8.07927 32.7478 0.0743051 -3598 4 17.5012 19.6463 39.9647 -0.891206 -23.8414 -20.0908 -3599 4 17.261 19.5796 38.3923 8.05332 -16.519 21.1694 -3600 6 46.2326 27.6801 33.704 6.45393 -8.86534 7.23017 -3601 4 46.097 28.3723 33.048 -4.6559 5.79968 -1.93617 -3602 4 45.5979 27.7746 34.4233 -3.33861 16.4707 5.34235 -3603 6 35.8364 29.5448 5.62541 9.64171 -18.9009 -6.27826 -3604 4 35.5566 29.3199 4.72548 3.62776 14.0584 -3.56087 -3605 4 35.3944 30.354 5.86953 -6.57081 16.5188 2.47276 -3606 6 47.2881 25.7744 30.172 -6.62968 25.0044 -44.0548 -3607 4 48.1218 25.8653 29.6696 -5.94381 -7.49802 14.0131 -3608 4 46.6882 26.3745 29.6449 8.85802 -15.1094 17.4745 -3609 6 51.3842 12.359 20.0239 24.4626 17.3052 -5.31346 -3610 4 50.8707 12.833 19.3583 -10.0057 -7.98386 3.51527 -3611 4 50.8448 11.6564 20.3722 -11.0446 -8.70835 7.6307 -3612 6 41.976 18.3776 28.9581 25.2971 -7.26912 -18.3725 -3613 4 42.7018 17.9973 28.405 -17.3573 7.64094 3.96866 -3614 4 42.4517 18.9921 29.5246 -2.74764 -0.293653 0.793262 -3615 6 53.6043 6.48027 7.50524 -23.0657 -32.6432 -30.9738 -3616 4 53.1601 5.59498 7.33399 18.2827 28.6912 7.08019 -3617 4 53.6632 6.576 8.44633 9.6706 -3.87944 16.2616 -3618 6 9.90786 10.6094 26.7582 6.17728 8.73826 28.1859 -3619 4 10.299 10.3755 27.6331 -6.59671 -6.24018 -20.7073 -3620 4 9.65116 11.5299 26.9247 0.732239 -5.98194 -12.944 -3621 6 9.31054 39.3957 29.7756 40.7644 23.7808 19.8799 -3622 4 10.1982 39.3563 30.2561 -34.3316 0.809436 -14.8313 -3623 4 8.83679 40.1565 30.1832 5.55001 -15.1294 -12.8037 -3624 6 33.4099 4.77839 0.03236 -17.6047 -18.7695 14.8321 -3625 4 33.6454 5.53147 41.4176 15.8926 12.9618 -7.52592 -3626 4 34.0969 4.09847 41.8942 -0.186489 10.0102 -3.03658 -3627 6 35.7116 10.6673 34.2398 36.7653 -21.2814 -15.2586 -3628 4 35.2554 10.867 35.0388 -18.8422 0.575424 27.4634 -3629 4 36.4577 10.0619 34.4978 -21.6361 17.9445 -5.28322 -3630 6 15.2039 17.4016 19.1867 13.7018 -34.0248 -48.7675 -3631 4 15.5709 16.9982 18.3093 -23.7907 16.5473 43.0322 -3632 4 14.2523 17.472 19.021 -2.02403 4.48523 -0.714523 -3633 6 17.4757 37.6682 15.4227 -5.7624 0.927264 51.2416 -3634 4 17.0409 37.838 16.3209 3.67045 -5.85113 -35.7653 -3635 4 18.3529 37.3927 15.7202 1.879 4.38305 -13.464 -3636 6 26.263 8.20496 21.7043 -12.9193 13.0258 38.8746 -3637 4 26.2935 8.46487 22.6678 13.4631 -3.74504 -28.0146 -3638 4 25.3122 8.09558 21.5911 -4.90698 -1.77416 -12.6216 -3639 6 0.327844 9.89683 15.4174 -28.4002 -4.57955 -27.8061 -3640 4 1.20252 9.6859 15.1701 33.2298 -8.84956 3.25601 -3641 4 54.8213 9.3498 14.7471 -0.695723 21.8052 24.8209 -3642 6 13.451 40.6616 9.29616 -29.1589 -29.1317 3.11657 -3643 4 12.531 40.2581 9.2528 27.9164 27.237 1.6895 -3644 4 13.9533 39.998 9.7876 1.76749 3.89663 -1.50565 -3645 6 49.5605 25.9144 33.0102 6.77982 -23.7672 54.8124 -3646 4 50.0733 25.5846 33.8473 -25.1648 19.9091 -52.5505 -3647 4 48.6275 25.6453 33.15 14.5478 0.915879 -9.46863 -3648 6 37.0796 40.0419 26.4359 -26.9931 13.9721 12.3681 -3649 4 36.1882 39.5442 26.6099 42.8933 36.2545 -2.50818 -3650 4 37.051 41.026 26.6764 -12.8506 -44.3362 -9.04112 -3651 6 47.9916 17.8545 12.1553 -7.21137 29.6324 -37.7219 -3652 4 47.6652 18.6843 11.7058 6.42171 -29.0319 9.52509 -3653 4 47.7397 17.941 13.056 -8.12129 -2.80141 29.1943 -3654 6 27.9724 29.0571 34.165 6.45289 -21.5611 -2.40729 -3655 4 28.8948 28.8211 34.3683 -10.3018 1.8492 -2.91154 -3656 4 27.944 30.0064 34.1676 -0.713497 24.9251 0.854011 -3657 6 33.997 2.77014 13.2231 -35.3168 39.3397 6.14274 -3658 4 33.7592 2.40426 14.0871 -4.38792 -6.80294 -4.34532 -3659 4 34.7545 2.32608 12.931 40.4814 -27.3629 -5.76242 -3660 6 28.4454 36.033 11.4537 -30.811 -5.98685 22.1865 -3661 4 27.9997 35.3658 10.9161 0.521783 -1.73573 4.3727 -3662 4 28.9676 36.474 10.8303 31.7187 19.1344 -28.008 -3663 6 36.1836 11.3675 28.8638 -20.2526 -8.96451 -46.9053 -3664 4 35.201 11.3136 28.8426 17.393 5.15327 13.3727 -3665 4 36.3619 11.2493 27.8855 5.85658 3.26624 29.9739 -3666 6 24.7946 39.4802 16.9069 19.0937 3.96627 -8.4872 -3667 4 24.3751 40.345 16.9988 -5.97342 -3.52606 0.908874 -3668 4 24.9466 39.3518 15.9585 -10.9099 3.48913 2.54936 -3669 6 49.9504 8.05659 22.8451 -38.4139 -9.47108 -34.4931 -3670 4 49.9375 7.9588 23.7925 -16.1787 -3.75115 16.4902 -3671 4 49.0231 7.8493 22.4633 39.8101 3.17892 24.2331 -3672 6 52.1004 19.3469 10.2236 -1.12118 28.0811 1.24376 -3673 4 51.6057 19.3908 9.40186 -4.74475 -17.9853 -5.36861 -3674 4 52.3066 20.3081 10.2872 8.90847 -30.6944 7.30622 -3675 6 24.8344 15.8907 6.13046 -10.5287 3.62194 6.20212 -3676 4 24.2343 16.3288 6.78807 10.5214 -9.32926 -18.7028 -3677 4 24.4584 16.0701 5.24836 4.34413 4.47582 9.48796 -3678 6 49.3142 23.7074 8.6354 12.7826 -64.5552 32.8663 -3679 4 49.2168 22.9153 9.25307 13.1077 36.9849 -24.4484 -3680 4 48.4233 23.9587 8.46247 -20.5325 16.4959 -12.9251 -3681 6 0.200228 10.6387 32.1899 4.57462 9.08702 -50.3173 -3682 4 1.12405 10.3631 32.1441 4.84637 -6.06001 20.7538 -3683 4 54.8206 10.7585 33.0477 -1.25869 -8.0958 33.7963 -3684 6 12.5866 32.9145 13.2359 -45.84 -1.33101 12.3773 -3685 4 11.7384 33.4448 13.1799 26.1773 -16.8128 -1.90055 -3686 4 13.2757 33.4614 12.9111 20.4647 17.7705 -9.07485 -3687 6 21.729 32.5695 14.1172 -9.28791 -20.3928 5.37861 -3688 4 21.166 33.3661 14.1597 2.78901 -9.86158 3.94413 -3689 4 21.3002 31.8069 14.587 7.27427 31.5827 -10.8786 -3690 6 48.1522 34.8482 27.3304 1.15431 -17.6089 -40.5894 -3691 4 47.5385 35.1725 27.9994 -6.04073 -2.93057 -0.479876 -3692 4 47.6796 34.4132 26.5454 8.99615 21.2578 35.6726 -3693 6 45.6357 31.2393 36.095 -40.8957 20.4658 25.2026 -3694 4 45.8476 31.9489 35.493 1.2761 6.76392 -14.6383 -3695 4 44.8829 31.5945 36.6582 19.8537 -10.4851 -18.3708 -3696 6 46.2846 0.316369 14.3569 -23.6541 -29.5796 11.0344 -3697 4 46.2347 1.24867 14.1822 6.12226 14.592 -0.646978 -3698 4 47.172 41.8876 14.3137 22.6277 5.76419 -11.0491 -3699 6 14.3437 18.9821 40.2104 -25.2995 -33.3041 -15.9392 -3700 4 14.4094 19.2869 39.3238 4.54227 2.45102 -23.4893 -3701 4 14.593 19.7098 40.7196 18.3341 34.8836 33.2243 -3702 6 14.5595 1.13832 10.2184 21.0915 11.237 11.4523 -3703 4 15.4791 1.15983 9.85648 -24.9846 -0.242798 0.374642 -3704 4 14.0639 0.416501 9.81608 3.47586 -8.24251 -5.69878 -3705 6 34.4238 40.9137 13.0059 -4.24882 -26.6665 -25.0696 -3706 4 34.0907 40.4301 12.2099 6.6876 25.2293 12.1693 -3707 4 34.3655 40.2093 13.6737 -1.45879 20.9599 -0.365544 -3708 6 42.1372 25.6317 33.9946 32.9644 -29.1434 -4.32848 -3709 4 41.7256 25.3671 33.1599 -4.34041 1.82357 5.58197 -3710 4 42.8775 24.9612 34.1276 -26.6125 21.4128 -4.76888 -3711 6 29.2041 22.5904 40.0709 -12.2401 -3.24737 -11.2113 -3712 4 28.5312 23.0545 39.5673 2.40343 6.95864 -1.48823 -3713 4 29.0042 22.7646 40.9807 1.44808 0.219743 17.343 -3714 6 44.8039 18.6198 1.5029 3.83338 16.5679 14.3409 -3715 4 44.9659 19.0204 2.39019 -3.90529 -17.866 -14.3425 -3716 4 44.0478 19.1074 1.16429 2.25905 3.06151 -3.31671 -3717 6 4.48486 10.8191 23.9456 -47.6019 -35.9978 3.19751 -3718 4 5.13394 11.3869 23.6113 33.8353 31.137 -11.4748 -3719 4 4.52769 10.7271 24.8961 2.68899 9.9192 5.78369 -3720 6 6.46393 23.0191 29.0034 23.802 4.69353 23.6764 -3721 4 7.14249 23.0161 29.7285 -18.6834 17.7038 -21.9419 -3722 4 6.49076 22.0968 28.8008 -10.0115 -22.5628 -12.4771 -3723 6 39.7912 25.1434 32.5739 17.5205 -18.6836 -60.5647 -3724 4 39.6128 25.3468 33.4485 -16.6712 22.7672 53.7369 -3725 4 39.6667 25.9357 32.0325 -1.3786 -0.359445 4.68486 -3726 6 40.844 21.4875 8.87812 10.6958 -1.16061 -24.4784 -3727 4 40.753 21.3778 7.91779 -6.86728 3.07162 8.13114 -3728 4 41.3272 20.6946 9.13123 4.7165 -6.17308 11.2164 -3729 6 0.614957 1.42802 12.9561 35.282 30.4207 -35.1483 -3730 4 54.8795 1.90166 12.5287 -4.84596 -15.7095 11.3484 -3731 4 0.325279 0.716474 13.4972 -22.2917 -16.9379 18.816 -3732 6 32.6687 29.7155 23.4821 0.172893 -14.8348 21.3896 -3733 4 32.2937 28.8037 23.5347 8.27316 18.2339 -7.75927 -3734 4 32.5776 29.9928 22.5742 -5.86304 -0.191283 -15.879 -3735 6 12.5314 37.1515 20.4729 45.6241 64.5302 32.6184 -3736 4 13.0675 37.1561 21.3077 -14.1528 -0.638655 -18.1117 -3737 4 12.0966 36.3476 20.454 -27.4762 -63.6198 -6.10217 -3738 6 13.8924 14.5151 24.69 -3.15938 -4.02598 20.115 -3739 4 13.491 15.2498 24.2338 -4.44789 9.69439 -9.34194 -3740 4 14.0279 14.8194 25.6039 -0.281954 0.872924 -9.09093 -3741 6 17.5021 27.063 26.4741 18.9499 -7.93165 -17.7551 -3742 4 17.3645 27.9616 26.0981 5.20292 -20.1733 2.46217 -3743 4 18.105 26.551 25.8503 -19.0729 23.9469 15.4793 -3744 6 54.4877 9.53021 26.3477 -5.78247 7.96784 25.4661 -3745 4 54.0512 10.3733 26.628 8.34027 -15.1138 -9.49744 -3746 4 54.8923 9.139 27.1544 -8.60221 9.32804 -13.3813 -3747 6 33.6807 21.5011 24.9225 20.8165 12.7411 -37.5161 -3748 4 33.6447 21.5342 23.9109 -0.857654 -11.0597 35.2787 -3749 4 32.8481 21.1477 25.2212 -19.5227 -6.82771 5.56304 -3750 6 22.1475 35.2701 2.885 -1.57378 -2.18642 30.1771 -3751 4 22.1887 34.3602 2.5781 3.09514 -3.18559 -9.19859 -3752 4 22.1072 35.1817 3.87164 0.12039 0.813186 -18.6146 -3753 6 45.3027 5.41438 15.6133 24.4211 -32.124 17.7203 -3754 4 45.2073 5.06649 16.5292 -4.89018 16.6426 -14.7318 -3755 4 44.541 5.92364 15.3615 -17.3903 4.72304 -1.03383 -3756 6 5.67534 7.5869 16.981 -5.47297 6.8358 -20.2139 -3757 4 5.25896 7.81046 16.1225 6.35918 -0.232773 12.9215 -3758 4 6.51331 8.07041 16.9918 4.7107 -6.94883 2.60141 -3759 6 34.576 39.0992 27.2053 24.5889 13.5844 -33.9491 -3760 4 34.3093 38.4547 27.8221 -16.0328 -19.2876 29.327 -3761 4 34.0621 39.904 27.3046 -7.96056 4.01318 13.6593 -3762 6 32.7541 33.6107 34.2903 -12.2088 11.6467 -22.6039 -3763 4 32.1008 34.0277 33.6489 27.9813 -13.6615 23.3944 -3764 4 32.6574 34.0489 35.1447 -11.8345 -0.637226 -0.957772 -3765 6 31.0088 41.2052 32.3952 -16.5884 -4.13679 -5.08533 -3766 4 30.2065 41.1942 32.9317 -1.71273 -1.00977 6.80252 -3767 4 30.9738 0.147898 31.9828 5.47722 15.337 -6.15299 -3768 6 7.65161 1.58314 27.1492 34.9115 -9.04616 -23.8477 -3769 4 8.49581 1.43905 26.61 -35.9655 -7.00487 18.1392 -3770 4 7.51162 2.51613 27.0476 -4.48076 16.5289 1.77021 -3771 6 0.884173 22.0999 37.8474 19.5684 -22.3581 -15.9684 -3772 4 1.29289 21.3236 37.3582 -15.3878 24.821 16.8607 -3773 4 1.19208 22.8872 37.3739 -1.97361 -3.14502 -0.467946 -3774 6 7.41204 11.1157 19.2314 -38.1481 -15.0427 -1.85178 -3775 4 7.53858 12.0593 19.2468 12.5581 17.6457 8.19935 -3776 4 8.2604 10.6916 19.3015 17.9889 5.14781 -4.65775 -3777 6 43.7858 12.4956 37.3097 0.920036 9.73958 -3.1733 -3778 4 43.9612 12.5094 36.3537 -0.436236 -2.21513 6.60981 -3779 4 44.6264 12.7918 37.692 -0.443403 -7.75914 -0.361508 -3780 6 29.0868 33.5248 36.1867 6.33086 18.8505 -43.8567 -3781 4 29.87 33.99 35.8176 -18.9328 -5.41066 10.4629 -3782 4 29.4633 33.0358 36.8874 15.3521 -14.5291 31.9885 -3783 6 14.802 4.59099 3.93345 20.4849 22.8827 12.2406 -3784 4 14.3757 4.0439 3.27797 -5.14737 -6.71868 -8.73832 -3785 4 15.6594 4.91612 3.57855 -16.4986 -14.1515 -5.85747 -3786 6 39.0551 6.39795 6.38864 -31.6963 1.09254 42.8867 -3787 4 39.3692 7.21691 6.04781 17.6944 18.3081 -17.2196 -3788 4 39.3538 5.69048 5.84285 10.6785 -8.50098 -20.4551 -3789 6 22.2123 37.9977 40.776 -14.7699 -23.2033 -28.4168 -3790 4 22.4586 38.8695 40.5021 9.68098 25.7962 -2.3277 -3791 4 22.4791 37.9118 41.6765 7.85923 -2.07179 26.9545 -3792 6 4.44877 23.2867 6.14309 -1.92846 -21.7963 14.7751 -3793 4 3.85981 23.8785 6.59389 -8.34079 22.3777 -5.30491 -3794 4 4.15148 22.4458 6.53602 18.5324 -1.87236 -10.5169 -3795 6 12.4298 23.7885 9.24819 15.5635 1.24594 19.7483 -3796 4 11.6299 23.5219 8.81427 -22.2296 0.449899 -3.14002 -3797 4 12.2156 24.1823 10.1208 2.55292 -1.37139 -18.7826 -3798 6 46.4922 15.2589 16.9667 3.22745 3.94864 2.0367 -3799 4 47.1791 14.9867 16.3488 -1.59454 -10.7105 -10.6804 -3800 4 46.8221 16.1143 17.2497 1.89409 2.98219 12.0057 -3801 6 34.1117 27.1644 19.7797 24.4736 -11.2812 21.2279 -3802 4 34.8774 26.5238 19.7962 -19.6491 14.1094 -6.20677 -3803 4 34.0324 27.4806 20.6991 -2.21978 -4.312 -16.0235 -3804 6 46.9479 13.2121 35.1109 14.7829 18.0264 15.8687 -3805 4 47.3232 14.0654 34.8894 8.1348 3.75559 6.81177 -3806 4 46.5576 12.9943 34.2929 -17.7211 -19.0679 -23.646 -3807 6 50.5883 18.7922 12.536 -4.97475 -8.40096 -18.6689 -3808 4 49.7377 18.4417 12.2063 9.85466 0.19572 8.20723 -3809 4 51.2037 18.6585 11.7837 -7.44169 10.1395 9.07394 -3810 6 32.4871 12.6357 31.9554 3.75694 -28.5712 -45.9238 -3811 4 32.607 11.6542 31.8864 5.47128 21.8321 9.55763 -3812 4 32.4011 12.8494 32.8587 -4.02679 2.16968 41.7104 -3813 6 6.20502 19.6778 10.0162 1.71901 21.9334 16.0314 -3814 4 6.41826 20.2441 9.25697 6.75258 -1.0862 1.44387 -3815 4 6.08129 20.3112 10.7738 2.93045 -16.0896 -19.0741 -3816 6 21.5254 21.5246 2.44441 10.1652 3.23891 -24.6245 -3817 4 21.7373 21.5014 1.49425 -3.90993 5.22039 4.49463 -3818 4 22.0841 20.8004 2.76184 -10.1442 1.98878 12.5692 -3819 6 38.3901 23.0895 17.1987 11.9637 -29.1373 -23.0023 -3820 4 38.7115 23.1739 16.2902 2.30233 23.4463 5.8212 -3821 4 38.6091 22.1461 17.2941 -10.4226 8.48715 23.8901 -3822 6 29.6992 24.9636 22.2212 38.6917 -37.4999 -9.7813 -3823 4 30.2244 25.0209 22.9989 19.9484 -5.9881 25.7874 -3824 4 29.0295 25.5321 22.4534 -63.588 46.0104 6.14599 -3825 6 30.2959 21.4331 37.7732 -36.6703 24.7369 -1.55525 -3826 4 30.3833 21.3736 36.7928 -5.6984 1.01251 23.2154 -3827 4 29.3642 21.7906 38.031 44.833 -25.8334 -23.6526 -3828 6 11.8968 11.712 16.3062 -52.2626 -16.509 -42.1992 -3829 4 11.3487 12.2512 16.8737 -4.04714 4.99791 6.8918 -3830 4 11.2749 11.5458 15.4981 35.5887 6.11969 38.645 -3831 6 5.69762 16.9728 10.4703 1.06122 -0.586779 5.28994 -3832 4 4.99177 17.1708 11.0979 -1.96678 -11.04 -5.71485 -3833 4 5.85288 17.8179 10.0528 3.40155 4.97172 -3.96907 -3834 6 41.7052 34.1635 35.8846 2.77529 22.9845 38.2917 -3835 4 41.9958 35.0267 36.2582 -8.6238 -19.1969 -5.00662 -3836 4 41.6615 34.3005 34.9574 -2.57818 -0.630621 -34.674 -3837 6 33.7668 1.16041 30.1021 -7.73366 -5.3538 60.0773 -3838 4 32.8437 1.27671 30.3431 -6.56672 10.3256 -18.6068 -3839 4 34.0939 1.04339 31.0463 15.1522 -1.22783 -40.312 -3840 6 50.3589 18.6227 36.9888 29.2523 22.0538 -2.88024 -3841 4 50.1022 18.8636 37.8788 -6.7252 3.81489 7.59342 -3842 4 49.7597 17.9698 36.6907 -30.5426 -29.286 -11.4073 -3843 6 24.6818 24.2557 40.239 -30.3362 18.6852 9.52233 -3844 4 23.7683 24.4347 40.5809 21.1328 -2.57181 -5.50386 -3845 4 24.791 23.3075 40.3447 2.5826 -1.14956 -5.51696 -3846 6 37.3025 22.0306 23.2304 -1.24857 -1.55203 26.5345 -3847 4 37.0034 21.8174 24.1364 -3.77965 7.42086 -11.5868 -3848 4 37.7677 21.2337 22.9852 8.84969 -1.31238 -13.2672 -3849 6 48.4163 40.4951 28.9695 -6.68628 11.813 -16.9736 -3850 4 49.0084 41.2243 28.7075 -10.6266 -4.31108 -6.63999 -3851 4 47.6767 40.479 28.3098 12.2088 -0.876211 11.6705 -3852 6 24.8524 8.74511 16.566 -5.47802 -1.24744 16.6444 -3853 4 25.3154 9.32041 17.1898 2.58295 -0.80606 -7.28092 -3854 4 25.3735 7.93816 16.4942 1.51819 -5.71343 -7.74972 -3855 6 19.2312 23.0154 32.4581 7.29767 -10.2486 -2.08042 -3856 4 18.4295 23.4489 32.1618 3.75321 4.57429 -6.83594 -3857 4 18.9208 22.4103 33.1253 1.01223 -4.21105 8.69504 -3858 6 3.33807 21.6805 22.4551 -46.3933 -7.60477 16.0737 -3859 4 2.65604 22.1286 23.0335 23.3212 -20.9163 -13.0515 -3860 4 4.02869 22.318 22.3903 27.1551 13.0827 -5.07429 -3861 6 10.2258 20.3371 12.829 -8.54969 -20.6717 -8.68144 -3862 4 9.56384 20.8338 13.3253 4.28314 2.73019 -3.94148 -3863 4 9.70568 19.6401 12.367 8.3544 15.6282 9.01344 -3864 6 9.53393 0.668964 25.3385 8.23748 17.1946 -9.08311 -3865 4 10.3992 0.538209 25.8183 -20.1327 16.9559 -17.4439 -3866 4 9.57635 1.38514 24.6117 12.9812 -33.3008 29.4344 -3867 6 10.6624 40.712 9.64369 -16.6479 -8.09828 -30.6343 -3868 4 10.6692 41.3905 10.303 1.51816 10.4523 18.0663 -3869 4 9.97599 41.0031 8.99599 12.0328 -9.66263 16.6565 -3870 6 46.359 25.2248 32.6769 -14.7838 37.2607 37.796 -3871 4 46.1367 26.0735 33.2154 13.6855 -48.6436 -31.9122 -3872 4 46.6282 25.5659 31.8216 4.36769 -3.83668 -6.22015 -3873 6 38.9431 3.2028 23.1016 18.0409 -17.6687 24.963 -3874 4 38.0396 3.32435 22.9005 -28.138 13.963 -19.732 -3875 4 38.8834 2.64883 23.9052 13.1186 5.8311 -6.82495 -3876 6 33.334 23.6417 36.8871 -1.6197 -14.346 14.9842 -3877 4 32.7695 23.6175 37.7211 18.6046 10.6207 -30.6843 -3878 4 33.5528 24.5621 36.6745 -4.59115 1.63353 1.59233 -3879 6 51.9355 33.3272 25.435 24.4931 61.1901 -39.0042 -3880 4 51.4286 33.1494 26.1943 -20.5556 -13.8295 37.3068 -3881 4 51.9313 34.3506 25.3627 -2.33157 -52.0679 -5.38276 -3882 6 32.1777 25.0215 33.1655 -4.40266 21.2191 -9.05445 -3883 4 32.7541 25.8194 33.0841 -10.7751 -17.7804 3.95932 -3884 4 31.2703 25.3891 33.0319 13.5135 -10.8842 0.697404 -3885 6 51.2858 27.7149 39.5023 -29.438 -28.7732 26.1015 -3886 4 51.6029 27.7352 38.6212 16.0201 9.86215 -30.6452 -3887 4 51.6337 28.456 39.976 12.6328 17.4546 7.30145 -3888 6 34.2938 28.319 17.2582 8.1769 -6.30709 4.0332 -3889 4 33.5147 28.7567 16.9609 -27.2201 13.5182 -7.119 -3890 4 34.2215 28.3851 18.2119 5.48963 -10.3892 10.8325 -3891 6 36.9125 8.03614 37.8626 31.6258 41.6511 37.5008 -3892 4 37.1772 8.64874 37.1722 -6.23292 -16.4311 -22.0997 -3893 4 37.3691 8.52088 38.6203 -30.9712 -36.3395 -15.9768 -3894 6 34.8794 19.4073 6.12479 12.5531 6.66298 1.29528 -3895 4 34.0931 18.8687 6.15723 -9.84615 -2.81902 0.903663 -3896 4 34.5874 20.3343 6.07707 7.75337 -1.04832 -3.72421 -3897 6 52.9388 9.46792 7.82791 49.0384 32.8563 -49.3294 -3898 4 52.8922 10.1625 7.06425 -6.6048 -31.3865 41.9454 -3899 4 52.145 9.34409 8.30569 -37.6802 7.72308 13.142 -3900 6 36.3078 5.4787 38.9756 -59.3492 -35.3574 -23.3076 -3901 4 36.7604 5.44249 39.7856 34.2456 7.44664 27.0781 -3902 4 36.4713 6.28646 38.5283 19.3627 32.146 -13.2298 -3903 6 10.0102 14.4476 13.47 7.45507 32.9986 11.9551 -3904 4 10.2267 15.3574 13.7991 -6.33005 -21.0964 -5.42394 -3905 4 9.26267 14.5991 12.8847 -7.70629 -5.78085 -0.713961 -3906 6 17.2158 24.3617 39.7859 1.82925 -26.4802 17.5225 -3907 4 16.9252 25.2477 39.6578 -10.2532 23.1813 -8.78866 -3908 4 16.8659 24.1409 40.6742 12.3143 -2.49802 -8.33055 -3909 6 49.0708 32.5605 7.76617 4.98775 -19.9892 12.4117 -3910 4 48.2488 33.0406 7.85919 -4.66971 4.38963 1.84033 -3911 4 49.5854 32.9586 7.08254 9.03816 10.9607 -18.1455 -3912 6 44.8772 24.3958 5.47001 55.4245 15.4507 -4.26518 -3913 4 44.8128 24.5742 6.41303 -16.1158 -0.171295 7.10823 -3914 4 44.0866 23.9971 5.17679 -42.0653 -18.1716 -4.3799 -3915 6 37.3106 29.1913 32.8596 13.2918 -7.82588 25.4298 -3916 4 36.7195 29.353 33.61 10.148 2.43022 -0.346483 -3917 4 36.7915 29.3572 32.1043 -27.5405 3.64351 -29.7293 -3918 6 0.903259 24.8209 21.2384 21.1637 23.8586 -12.5999 -3919 4 1.07153 25.1845 20.3306 -6.36458 -4.90686 24.2304 -3920 4 1.48599 25.3539 21.839 -15.2813 -16.355 -7.82064 -3921 6 53.0335 2.20305 13.0061 -8.76459 0.917863 -30.1717 -3922 4 52.7178 1.83592 13.8181 -1.16689 -4.66991 20.3458 -3923 4 53.3973 3.07458 13.1779 4.70755 1.41814 13.7418 -3924 6 24.3073 33.9788 13.9425 26.9643 -19.8352 3.53447 -3925 4 23.8166 33.1535 14.1304 2.48225 11.7572 -2.64876 -3926 4 25.2622 33.8278 14.204 -36.1259 9.29052 -3.07765 -3927 6 40.931 19.3008 0.314297 -22.2267 40.7784 4.53314 -3928 4 41.073 18.3876 0.266006 15.5735 -49.6404 -1.39225 -3929 4 41.7685 19.7545 0.415523 11.1161 2.19254 -0.550631 -3930 6 38.3131 32.0321 21.5909 -11.558 27.6654 -12.3629 -3931 4 37.7152 31.3901 21.181 3.54948 -0.803384 -4.61225 -3932 4 38.0485 32.9451 21.2634 6.02672 -33.9485 15.0266 -3933 6 42.3093 34.9988 16.9782 -31.0886 21.3467 -4.04435 -3934 4 41.4322 34.9872 17.4259 23.1708 5.16072 -1.2535 -3935 4 42.7209 34.172 17.1456 10.0707 -23.8474 2.85212 -3936 6 19.5555 24.3301 21.9337 4.81064 -45.312 41.7565 -3937 4 19.0503 23.5208 22.2695 18.6897 32.4519 -16.5084 -3938 4 18.9494 24.7901 21.383 -21.2783 9.24005 -16.3011 -3939 6 21.0765 3.08453 14.9497 18.8565 6.62045 0.482113 -3940 4 21.9827 3.42458 15.1377 -20.4059 -2.71097 -2.70114 -3941 4 21.0593 2.94323 13.9894 -7.00518 -5.35814 1.95693 -3942 6 16.4422 12.1477 28.531 -0.750899 4.00912 3.87665 -3943 4 16.9503 12.6102 29.2147 -1.62139 -0.392447 -5.94721 -3944 4 15.8278 12.7952 28.1633 1.40376 -4.03425 1.22377 -3945 6 29.5501 4.7113 21.752 31.6763 -19.7408 -11.7502 -3946 4 29.7575 3.81476 21.3864 -8.62397 20.1371 9.94028 -3947 4 28.6767 4.97136 21.4837 -14.307 1.15287 -5.34284 -3948 6 47.4015 12.0887 13.4082 -20.234 -20.0739 19.2385 -3949 4 46.7896 12.1748 12.658 5.24956 2.33261 8.08179 -3950 4 46.8763 11.6307 14.143 25.8489 23.9178 -32.3489 -3951 6 26.4368 0.034911 5.58657 -64.7941 -10.5287 17.818 -3952 4 25.4579 0.386547 5.64311 57.7785 -5.53424 -8.5606 -3953 4 26.2825 41.0177 5.90114 11.1228 18.2746 -10.9356 -3954 6 20.8239 34.8091 41.3451 3.02448 22.7042 23.7072 -3955 4 20.8848 35.7307 41.7064 -1.83719 -23.2001 -12.5561 -3956 4 21.5135 34.3024 41.8142 -0.435548 5.34794 -5.15218 -3957 6 12.6914 17.4806 1.38079 -1.22179 11.8948 19.0955 -3958 4 12.6924 17.2614 2.32235 1.20892 0.120609 -3.36771 -3959 4 12.6119 16.652 0.923905 -0.609755 -13.5185 -16.0456 -3960 6 30.0783 10.198 8.41195 2.12134 -1.25171 -25.3141 -3961 4 29.3533 10.7626 8.0964 5.01977 -3.23694 0.534487 -3962 4 29.9182 10.0601 9.33268 -3.94599 -2.47727 24.1034 -3963 6 36.3506 5.44781 23.9083 -0.549638 14.3818 20.7021 -3964 4 36.0156 6.32048 23.6328 6.62881 -2.58855 0.476976 -3965 4 37.0027 5.63115 24.6267 -8.58297 -8.41851 -13.9364 -3966 6 34.0301 39.9488 19.4964 -23.0399 -20.8249 18.5921 -3967 4 34.456 39.4415 20.2152 6.93565 15.6495 -14.2212 -3968 4 34.6348 40.5483 19.0534 11.5364 2.12704 2.14354 -3969 6 25.0981 29.0133 17.0022 63.4673 53.603 -24.6749 -3970 4 24.4066 28.4545 17.2066 -49.3728 -47.1307 14.2315 -3971 4 24.9323 29.3693 16.11 -4.01222 -10.2038 10.3173 -3972 6 28.4991 21.3215 6.5284 30.3134 51.3135 12.4116 -3973 4 28.073 21.8131 5.82363 -12.0684 -17.0718 -17.6117 -3974 4 29.0439 22.0969 6.88435 -18.1485 -38.7813 5.23359 -3975 6 18.6639 26.1486 0.434559 17.278 41.4043 -10.2832 -3976 4 18.2934 25.3073 0.618971 -26.4426 -25.2614 5.85754 -3977 4 18.1648 26.8598 0.892557 2.28699 -17.4047 3.2853 -3978 6 10.9881 29.7025 15.4563 -76.0882 18.6105 19.9394 -3979 4 11.66 29.3744 14.945 58.6215 -25.2203 -34.7363 -3980 4 11.3165 30.0451 16.2682 18.0847 5.23212 20.5617 -3981 6 33.4842 3.75768 10.5858 0.636803 10.5574 28.6939 -3982 4 33.4734 3.50079 11.5612 -0.522502 1.02567 -36.066 -3983 4 33.5593 4.73652 10.6 -0.068286 -14.4363 0.33475 -3984 6 12.2823 28.8038 23.0281 11.3775 -6.29424 6.84391 -3985 4 12.7596 29.6284 22.9364 3.04418 8.52871 -1.54448 -3986 4 11.6562 28.9633 23.7417 -11.9653 1.92572 -6.97409 -3987 6 13.0879 10.2853 41.0171 -47.2786 6.02767 7.69694 -3988 4 13.8008 10.0588 41.5617 38.8858 -12.6991 24.323 -3989 4 13.445 10.533 40.1929 12.5253 9.31307 -31.237 -3990 6 45.8279 29.9763 22.3517 -19.0059 -47.3471 -0.794771 -3991 4 46.3385 30.6632 22.7121 22.9496 35.5749 11.5915 -3992 4 46.1736 29.1608 22.8005 -10.4716 15.4455 -15.9284 -3993 6 41.5587 12.1258 14.79 16.8952 2.46742 -19.497 -3994 4 40.8127 12.0778 15.3866 -8.88903 2.06539 11.4921 -3995 4 41.9001 13.025 14.8368 0.886253 5.83282 4.44761 -3996 6 18.1774 7.21532 24.17 -10.7079 71.0597 15.5191 -3997 4 17.3895 7.85304 24.2309 32.278 -29.8877 -8.26822 -3998 4 17.8432 6.3671 24.0218 -31.5603 -50.1252 -1.23769 -3999 6 1.46617 28.3087 7.5822 17.4051 32.8243 -18.4272 -4000 4 0.972435 27.5241 7.77639 -23.983 -7.56132 -3.64975 -4001 4 0.919057 29.0368 7.16413 8.17263 -22.6878 11.3207 -4002 6 11.3257 12.3178 24.0505 6.50608 36.5044 21.7543 -4003 4 11.787 12.9182 24.6663 -15.142 9.53056 -9.69028 -4004 4 11.7144 11.5384 24.3755 9.90684 -45.3393 2.97811 -4005 6 17.9727 40.4585 24.4268 -2.1753 13.4943 43.6914 -4006 4 18.2079 40.9973 23.706 15.3173 17.1897 -35.5256 -4007 4 17.8423 41.1404 25.131 2.16294 -27.9915 -10.5346 -4008 6 25.5983 7.44259 34.0136 19.3716 5.77393 -21.6373 -4009 4 25.8935 7.97324 33.2232 -7.88236 -13.8451 20.6491 -4010 4 24.6626 7.5793 34.1612 -12.3217 5.75259 0.6842 -4011 6 16.9533 36.3934 7.79695 -14.7733 -58.972 -15.2131 -4012 4 16.1509 35.7821 7.92089 32.5681 38.8119 0.0631702 -4013 4 16.873 37.2333 8.21975 -10.866 19.0251 14.3825 -4014 6 12.4478 39.1676 36.8063 -58.2746 -19.2691 -7.14825 -4015 4 13.2621 39.5728 37.0444 24.763 -2.90148 -1.94315 -4016 4 12.5678 38.2718 36.42 14.2903 21.5885 11.3364 -4017 6 23.4428 1.91286 37.7232 -9.22102 6.32267 -24.8838 -4018 4 22.7837 1.60923 37.0782 3.11058 2.78987 13.6287 -4019 4 23.6923 2.7833 37.361 6.97145 -2.92816 9.87668 -4020 6 26.6131 34.8527 39.0629 -0.358317 22.46 -5.08852 -4021 4 25.9211 35.0251 39.7209 4.63868 -0.642547 -8.45736 -4022 4 26.6245 35.623 38.4346 -11.8568 -25.3624 13.8384 -4023 6 44.7506 35.5772 23.1679 10.7298 -18.8811 -26.4233 -4024 4 44.6498 36.2622 23.8111 -7.39072 22.4611 10.5052 -4025 4 44.899 35.9413 22.2637 -2.27133 -5.1907 16.9936 -4026 6 34.6136 35.4178 26.71 -15.9342 1.46423 13.2724 -4027 4 33.7739 35.201 27.1682 15.3038 9.13482 -13.5788 -4028 4 35.2424 35.4667 27.4557 -1.55634 5.60609 -12.3698 -4029 6 12.4253 29.8367 9.37257 6.8074 7.71813 14.8361 -4030 4 12.5954 30.1793 10.279 -1.64518 -2.79843 -17.3301 -4031 4 11.9756 30.5342 8.87466 -2.55144 0.413422 5.70549 -4032 6 46.4578 41.3781 16.9525 -1.71223 -15.9012 -6.63524 -4033 4 46.309 0.164546 17.5847 2.66821 13.6546 8.2853 -4034 4 46.3887 41.8168 16.0911 -0.805017 -2.71613 2.08401 -4035 6 39.1753 31.0467 24.0118 -3.10819 6.08124 -21.6124 -4036 4 39.1065 31.2708 23.0301 -7.23524 -5.82233 36.9271 -4037 4 38.2867 31.0608 24.4123 9.52041 3.88051 -10.8568 -4038 6 40.5402 9.7597 28.9847 14.8037 -28.2595 -25.194 -4039 4 40.7176 8.78836 28.9335 -4.00485 22.4893 3.39032 -4040 4 39.9733 9.89103 29.7293 -9.65138 5.58475 19.0645 -4041 6 33.5593 11.9211 22.729 -1.15717 -3.69298 36.7387 -4042 4 33.4631 12.1387 21.8005 -14.8881 8.7456 -3.74916 -4043 4 32.9393 12.4796 23.2922 26.8098 -15.4098 -27.756 -4044 6 29.0159 38.7519 2.46278 27.6721 -15.5988 -40.3681 -4045 4 29.1586 39.6546 2.1748 2.74048 3.67355 2.54153 -4046 4 28.5501 38.8453 3.26351 -22.211 -0.421087 25.3577 -4047 6 51.2833 6.14739 28.3043 6.24107 -1.78447 -16.8419 -4048 4 51.6927 5.30788 28.0231 -4.79213 3.01935 13.8596 -4049 4 51.5671 6.73798 27.5888 -1.89698 -2.53529 10.4249 -4050 6 34.1064 16.6123 14.042 -37.0155 -16.4066 -7.07731 -4051 4 33.9904 17.5439 13.9588 -10.6946 23.5239 -0.125603 -4052 4 35.0244 16.4872 14.0391 48.662 -2.86898 -0.118382 -4053 6 34.4321 40.0645 7.48859 13.9518 5.57425 38.6209 -4054 4 34.6497 40.8416 6.93548 -15.3832 -25.9537 -5.407 -4055 4 34.0868 39.3056 7.01264 2.49953 7.17747 -18.8692 -4056 6 42.5297 22.9808 4.38266 2.56422 12.7755 -29.8183 -4057 4 42.7079 23.1404 3.43503 2.07895 -8.20356 9.72626 -4058 4 41.6007 23.2438 4.43282 3.68115 -1.88729 13.9368 -4059 6 1.41725 11.7089 10.583 40.9585 72.4956 7.82458 -4060 4 2.29602 11.7947 10.1149 -31.3121 -19.1762 2.07637 -4061 4 1.32217 12.6809 10.8959 0.250133 -47.8987 -12.0904 -4062 6 10.0222 17.1523 40.4009 -13.9984 -42.4532 23.0969 -4063 4 9.09922 16.7881 40.4362 25.3227 17.9847 -3.64852 -4064 4 10.5566 16.4623 40.9043 -11.7978 28.1532 -20.1855 -4065 6 26.3773 1.16785 23.7951 0.897687 17.1036 -20.4546 -4066 4 26.2949 1.59753 22.8926 6.72339 -10.2637 31.134 -4067 4 26.8106 1.83522 24.3632 0.404944 -5.36666 -8.232 -4068 6 4.47728 16.2319 39.0174 38.9165 -19.7518 -18.3291 -4069 4 4.60126 15.8787 38.0926 -3.95383 11.2541 23.7603 -4070 4 5.37849 16.1152 39.4714 -36.6531 9.54225 -13.0705 -4071 6 24.3645 39.8454 14.0862 11.6717 18.512 -7.42816 -4072 4 24.2179 40.7168 13.6655 -1.51261 -13.0973 5.973 -4073 4 25.144 39.5095 13.6466 2.38152 -7.3908 -1.6645 -4074 6 19.9724 19.004 10.1294 8.87966 -14.5095 2.71373 -4075 4 19.0999 19.3915 10.2782 -1.93643 -3.06257 7.63815 -4076 4 20.1403 18.2899 10.8137 -9.49435 28.7308 -18.8504 -4077 6 45.2455 15.0555 25.2985 9.44949 25.5865 29.6023 -4078 4 44.5225 15.6147 25.6238 -9.11717 -2.3226 -13.4673 -4079 4 44.9162 14.4027 24.6993 -17.0358 -18.2103 -14.0354 -4080 6 47.6513 32.9537 29.9733 -3.02769 -8.48031 15.1317 -4081 4 47.7848 32.4488 30.7976 5.01558 10.2706 -8.76515 -4082 4 46.6987 33.0693 29.9097 -5.02316 -0.316015 -4.02449 -4083 6 9.31033 14.1561 35.6305 -9.15199 13.4931 14.7277 -4084 4 10.2186 13.9515 35.3646 1.69372 -1.68405 10.862 -4085 4 9.25805 14.5533 36.5394 11.2175 -11.577 -22.5615 -4086 6 0.560208 28.7354 32.128 -23.2584 38.0618 20.8665 -4087 4 0.439761 29.1616 31.2639 2.79308 -8.58991 0.800302 -4088 4 0.67028 27.8063 31.9961 10.5465 -16.7679 -9.91325 -4089 6 26.1282 14.1993 40.8411 59.6454 -38.6249 5.43898 -4090 4 26.432 13.4524 41.4491 -20.3805 31.5142 -12.0858 -4091 4 25.201 14.2926 40.8644 -35.6636 2.31432 7.08225 -4092 6 38.0409 1.72795 37.3461 -15.986 9.3487 3.27435 -4093 4 38.337 1.77003 36.4219 -6.4212 0.733726 8.60438 -4094 4 37.1869 2.24333 37.3721 25.3175 -16.9011 -0.126137 -4095 6 43.391 21.0055 0.385428 11.1435 51.3868 10.1231 -4096 4 43.3728 21.9356 0.739051 -22.7765 -27.5137 5.23027 -4097 4 44.2566 21.1078 41.893 4.66373 -25.0138 -11.6612 -4098 6 29.7339 12.3948 17.084 15.7249 11.0657 13.1734 -4099 4 30.3928 12.9555 17.5239 -4.04604 16.1495 -27.1654 -4100 4 29.6387 11.801 17.8166 -19.321 -23.8097 4.84602 -4101 6 21.0831 10.9976 35.6454 20.8751 25.9078 26.8503 -4102 4 20.9144 11.9356 35.5 -2.5465 -0.914036 2.40284 -4103 4 20.6111 10.5739 34.9651 -17.7649 -25.2648 -31.6786 -4104 6 24.3635 22.1336 17.0651 -49.7832 5.03398 -16.9936 -4105 4 24.7447 22.8357 16.5516 14.0354 11.6369 -2.31656 -4106 4 25.0369 21.6158 17.4366 35.7007 -17.2122 18.4164 -4107 6 44.2543 9.63808 6.15039 20.313 -11.2139 14.5913 -4108 4 44.7688 9.46356 5.36091 -1.47318 -0.699349 -10.0319 -4109 4 43.371 9.9028 5.92157 -14.9065 6.10764 -5.2575 -4110 6 40.8032 2.87739 6.28666 -13.1289 22.479 10.901 -4111 4 40.3272 3.11809 7.09229 2.74106 -9.45257 -1.64817 -4112 4 40.5645 3.60702 5.69531 8.12536 -6.41414 -12.3146 -4113 6 23.4888 29.7691 25.1996 -20.8577 -7.3866 7.78845 -4114 4 23.0356 30.0691 24.4173 -11.1707 -5.96106 -7.76576 -4115 4 24.1981 30.3761 25.2406 38.2449 14.7306 0.541559 -4116 6 45.2336 20.6129 7.48752 -14.5833 -17.9538 -3.88696 -4117 4 44.4222 20.5961 6.94177 10.1673 3.83834 -0.615812 -4118 4 45.4226 19.6724 7.65027 4.1577 11.2609 0.378107 -4119 6 44.1804 26.5848 16.646 -7.77871 8.0927 60.0057 -4120 4 44.4497 26.5291 15.7549 9.82788 -17.3929 -39.3829 -4121 4 43.995 25.6977 17.0036 0.668911 -2.30329 -14.751 -4122 6 23.5902 27.0659 18.0913 -39.7013 -11.93 7.95298 -4123 4 23.083 26.2674 17.8176 19.208 11.4009 -9.44785 -4124 4 22.9184 27.4761 18.6801 25.6051 0.00742342 -8.40738 -4125 6 45.1467 16.0991 8.91755 -25.3782 -1.90264 -8.59791 -4126 4 44.1891 15.9425 8.7462 16.1978 6.4454 1.17339 -4127 4 45.2138 16.0078 9.87006 7.52298 -2.6657 10.2407 -4128 6 39.0203 15.1531 5.23259 28.6956 12.0263 -26.8074 -4129 4 39.7994 15.5772 4.7964 -10.087 -12.1112 6.39319 -4130 4 38.3368 15.7917 5.08662 -19.5574 10.6606 0.980846 -4131 6 40.468 4.77411 20.0927 -27.3359 -4.798 12.1592 -4132 4 41.2634 4.72652 19.6 29.6653 -1.38796 -18.2664 -4133 4 40.7147 5.23292 20.8909 -0.487482 4.30709 11.6637 -4134 6 35.8395 28.4372 39.9091 -50.8572 -25.335 -8.14583 -4135 4 35.0416 27.8127 39.7761 37.8149 25.8469 12.2999 -4136 4 36.4241 28.1912 39.1903 12.774 -11.5781 0.139918 -4137 6 26.5706 3.57143 2.67715 -46.9093 11.529 -12.2012 -4138 4 26.01 3.47498 1.86726 21.0232 -0.263485 19.1529 -4139 4 25.9795 4.13239 3.25499 25.5536 -16.3527 -3.3314 -4140 6 2.96374 21.6426 17.6806 -14.2306 -5.51577 -4.68338 -4141 4 2.93927 22.2072 18.4518 0.989431 6.72084 9.51867 -4142 4 3.70489 21.9005 17.1296 5.59779 10.8847 0.849605 -4143 6 12.8869 25.0552 25.9401 15.4127 26.4598 -14.83 -4144 4 13.2774 25.9118 25.6194 -5.06291 -21.1213 8.866 -4145 4 12.0842 24.9634 25.4247 -11.7493 -3.09829 -2.0396 -4146 6 41.5869 20.6707 14.1801 -22.4147 -6.05744 0.611169 -4147 4 42.2929 20.1295 13.8255 12.8925 2.43785 -7.39699 -4148 4 41.9118 21.5622 14.3536 8.70683 -8.7017 2.36606 -4149 6 1.26372 39.5934 11.5416 -2.31472 -23.2994 -17.666 -4150 4 1.60499 38.7626 11.0579 -12.721 36.8399 30.164 -4151 4 1.30151 39.4907 12.5143 8.15813 -4.07121 -11.1907 -4152 6 16.0274 39.0089 34.0759 -23.376 3.35378 -54.2756 -4153 4 15.5279 38.2654 33.6809 12.2329 5.59336 21.1278 -4154 4 15.9645 39.6681 33.3256 8.94624 -4.65522 31.8649 -4155 6 20.5749 7.01511 25.5545 -9.93748 22.9073 -1.77669 -4156 4 20.7998 7.9126 25.2373 7.69672 -13.5438 0.480138 -4157 4 19.6147 7.02086 25.4453 1.79337 -5.45304 -5.32881 -4158 6 45.1903 25.5946 39.1745 -26.3826 2.10768 23.1727 -4159 4 45.9078 26.0337 38.7511 23.0136 15.7961 -19.2282 -4160 4 45.315 24.6755 38.9972 4.74877 -22.0383 -3.82349 -4161 6 19.9254 40.1108 28.2935 0.936604 13.13 -6.83142 -4162 4 19.0415 40.3022 27.9603 -1.00367 -13.9734 -0.221352 -4163 4 20.1058 40.9072 28.8104 6.81084 -8.28794 7.10232 -4164 6 26.5025 14.2024 27.3816 7.55525 -11.5245 -39.7478 -4165 4 25.5661 14.1885 27.2241 -23.3405 -0.187867 -1.3667 -4166 4 26.5864 14.6167 28.2174 4.05242 7.69107 36.9512 -4167 6 51.349 25.9455 3.44193 13.1564 1.83251 -14.1309 -4168 4 51.0731 25.276 4.04973 -8.84751 -13.2679 15.0063 -4169 4 51.8098 25.4164 2.75525 -2.9574 19.5765 2.79729 -4170 6 20.1579 26.1269 2.66057 8.08543 -14.232 12.5138 -4171 4 20.4198 25.2285 2.95049 1.99012 13.1431 -7.88687 -4172 4 19.9848 26.1042 1.70984 -1.68704 0.137755 2.48294 -4173 6 3.12857 11.9594 27.2244 18.8731 20.7243 14.7894 -4174 4 2.60719 12.6622 26.8077 5.30838 -2.59233 -3.81502 -4175 4 3.76928 12.4285 27.8301 -19.9135 -11.7573 -12.7739 -4176 6 30.1745 26.3671 4.00755 44.117 -33.7612 35.926 -4177 4 30.7719 25.91 3.40695 8.20711 -11.5121 5.52432 -4178 4 29.6741 26.8182 3.4039 -49.0538 48.0497 -39.0484 -4179 6 19.309 20.6617 30.5327 -6.17305 20.3286 19.7257 -4180 4 19.3357 21.5037 31.0044 -16.2324 -1.53368 2.5841 -4181 4 20.215 20.6027 30.2783 24.1248 -10.9268 -16.9107 -4182 6 13.5428 36.2605 0.333332 15.0011 -10.6689 28.2547 -4183 4 13.9636 37.1467 0.274336 -13.564 -9.3403 -16.0521 -4184 4 12.8146 36.0991 41.6409 -4.77188 14.7057 -15.3617 -4185 6 13.69 21.7667 35.9665 -20.2473 -15.4187 -13.4538 -4186 4 13.4364 21.3658 35.099 7.7487 10.4825 13.8843 -4187 4 14.5406 22.1631 35.8296 17.4857 6.37333 -3.13554 -4188 6 39.4374 1.76506 25.3393 -36.4427 -7.29022 -10.5984 -4189 4 39.9364 2.34528 25.9215 16.7605 -3.08023 1.72977 -4190 4 39.8192 0.8892 25.1573 19.013 15.1682 11.727 -4191 6 18.3049 6.14326 35.8392 -10.8025 -19.5812 3.54688 -4192 4 18.125 5.32611 36.3393 4.50778 0.182671 -16.8727 -4193 4 18.2664 6.78418 36.55 10.3297 13.4079 -7.40032 -4194 6 2.50698 24.635 10.1008 2.82606 57.1639 14.1456 -4195 4 3.34783 24.2504 10.0645 38.9609 -42.7111 -6.9151 -4196 4 2.85647 25.509 10.4424 -34.1939 -15.4438 -5.60802 -4197 6 35.8245 9.94707 1.36321 12.392 22.5458 6.51215 -4198 4 36.2598 10.3662 0.602857 -1.03193 -1.33218 7.37913 -4199 4 36.14 10.4815 2.15194 -8.91958 -29.9524 -28.0328 -4200 6 29.0093 17.9332 41.5934 -7.9582 -11.0366 0.585828 -4201 4 28.5465 17.2289 41.1281 -16.7755 -3.81322 9.83818 -4202 4 29.6221 18.1453 40.9114 24.9254 25.1746 -10.164 -4203 6 46.0106 27.0842 25.8657 -15.8538 -10.6571 1.20957 -4204 4 46.7573 26.8966 26.4316 13.3887 1.52966 8.34957 -4205 4 45.3967 26.3449 26.0537 1.02353 6.85943 -7.5889 -4206 6 28.1115 10.6516 35.9124 -31.4415 -9.81676 -35.067 -4207 4 27.3321 11.0804 35.4953 10.9044 -14.8673 0.927998 -4208 4 28.4149 11.3158 36.4913 19.5717 24.3857 28.0975 -4209 6 25.9462 20.1874 24.7713 21.0981 19.7274 8.06252 -4210 4 26.7479 20.7296 24.6265 -12.3387 -9.71047 -3.27099 -4211 4 25.8934 20.1715 25.7373 -11.4252 -1.9185 3.65337 -4212 6 32.2315 30.2636 10.2038 46.2181 -42.2335 3.06511 -4213 4 32.6954 30.7903 9.55855 -13.4496 21.2522 -10.6663 -4214 4 32.9512 29.5744 10.3289 -28.7668 14.232 9.31608 -4215 6 5.05112 34.4033 23.8133 19.5013 -14.7597 17.0713 -4216 4 5.8904 34.9145 23.8209 -18.4686 -4.57798 -7.44977 -4217 4 4.4328 34.8283 23.2333 -4.78059 12.4432 -11.9709 -4218 6 29.6287 34.9421 23.1129 15.2461 20.4143 1.29823 -4219 4 30.2662 35.203 23.7945 -9.70178 1.77141 2.28452 -4220 4 29.7307 34.0083 23.0447 -4.13429 -24.1479 2.03513 -4221 6 52.1909 25.2296 36.2512 2.86438 -10.6824 22.6831 -4222 4 51.9483 25.3775 37.2028 5.23419 -4.07811 -26.4725 -4223 4 52.3343 24.2634 36.1804 -4.32722 6.81431 1.64545 -4224 6 6.96184 41.26 14.9825 2.80521 -5.8094 -40.534 -4225 4 7.04984 41.0874 15.8994 5.94782 -9.0625 22.8431 -4226 4 7.58542 40.6644 14.4953 -8.6815 16.2518 18.3581 -4227 6 27.6618 39.1341 4.65497 -15.321 -2.42325 19.5764 -4228 4 26.8583 38.6531 4.9607 13.8024 7.31782 -7.34321 -4229 4 28.2878 39.16 5.39008 -5.06496 -7.53921 2.22048 -4230 6 44.4448 15.8874 30.3939 -2.31018 0.103575 -22.4191 -4231 4 43.6353 16.4379 30.2788 15.6665 -12.4266 1.42045 -4232 4 44.7559 15.574 29.5018 -16.8402 11.4423 19.721 -4233 6 27.2939 38.1254 13.0955 15.3768 -40.6351 2.35664 -4234 4 27.6299 37.3572 12.5713 -6.06373 15.2601 5.99839 -4235 4 27.2975 37.7701 14.0147 -10.0522 11.5876 -10.9657 -4236 6 26.6773 32.9794 36.8294 -32.6396 -25.4624 12.1292 -4237 4 27.3491 33.5429 36.5103 30.2383 22.5556 -9.12925 -4238 4 26.1784 33.4868 37.4729 2.39424 7.35453 7.52648 -4239 6 26.3034 28.2003 31.7109 71.1077 16.3155 0.283388 -4240 4 26.8193 28.3341 30.863 -27.929 -6.55919 23.3278 -4241 4 26.9955 28.4613 32.4053 -35.143 -9.24619 -18.2719 -4242 6 49.2075 35.7729 23.3324 -21.4287 30.6035 9.89313 -4243 4 49.7648 36.3085 23.9054 5.92838 -6.84736 -0.0129328 -4244 4 49.7125 35.0813 22.9401 23.5965 -22.3057 -11.2126 -4245 6 44.2384 15.3735 33.5479 -0.546939 -12.4927 -0.897907 -4246 4 44.8734 15.133 32.8785 13.8917 -2.34347 -2.72297 -4247 4 43.5631 15.8174 33.0372 -7.79828 14.1806 -0.143619 -4248 6 16.6415 35.2629 14.0425 -13.711 -12.7272 -22.5016 -4249 4 16.8779 36.1297 14.3524 2.35153 17.3801 14.4176 -4250 4 15.7232 35.3535 13.695 18.4875 1.24889 7.88518 -4251 6 45.2979 21.4768 12.0753 -61.6802 -17.7786 9.36854 -4252 4 45.9745 21.1118 11.5746 47.2025 -15.5682 -31.9287 -4253 4 44.6407 20.7302 12.0307 13.4445 30.1014 15.4365 -4254 6 51.647 5.33893 20.0992 17.3373 6.85256 40.4731 -4255 4 51.8423 5.82757 20.9547 -12.0569 -16.4938 -26.4666 -4256 4 50.8652 5.75336 19.736 -8.70547 10.2387 -6.49138 -4257 6 22.616 27.3068 0.953729 -12.5585 5.72419 11.7926 -4258 4 21.9912 27.9206 1.39427 2.62886 -13.0847 -9.82719 -4259 4 22.9744 27.8285 0.229956 6.91293 3.08187 -2.36887 -4260 6 46.8924 12.1405 22.3241 28.0037 10.4006 6.07885 -4261 4 46.5361 12.6234 21.5839 -13.5229 3.11861 -11.9828 -4262 4 46.2058 11.655 22.757 -25.8682 -9.85748 8.02404 -4263 6 33.7577 5.61095 25.2306 8.81298 -10.6825 9.18366 -4264 4 34.4045 5.06092 24.7535 -5.77276 6.31779 -0.0821136 -4265 4 33.06 5.8369 24.6155 -4.37455 2.20678 -7.03208 -4266 6 44.2424 18.1337 27.2287 35.5912 4.17402 -1.61274 -4267 4 44.1428 18.6708 26.4104 -1.15401 -3.8952 20.8354 -4268 4 45.2041 18.2132 27.495 -32.4507 -0.562547 -10.2772 -4269 6 5.27745 36.9951 29.0779 -48.9341 45.2857 -18.2185 -4270 4 4.83797 37.847 28.7 19.7525 -41.2711 21.6555 -4271 4 6.18662 37.2124 29.1987 31.023 4.60304 7.81739 -4272 6 20.0415 5.02171 38.9415 13.5567 -45.1901 -20.6947 -4273 4 19.673 5.46942 39.6755 -5.65499 20.9205 26.8401 -4274 4 20.3443 4.13258 39.2728 -11.021 23.424 -4.53385 -4275 6 17.9077 2.77821 33.872 -28.7289 7.66476 22.1934 -4276 4 18.5675 3.36618 33.4993 11.2764 5.36232 -3.32863 -4277 4 17.289 3.30252 34.4687 25.3234 -20.0176 -17.8345 -4278 6 5.56252 23.3664 22.3199 23.4646 34.0494 22.6536 -4279 4 6.31266 23.4141 21.6995 -10.6272 -11.1368 -5.13028 -4280 4 5.83055 24.0852 22.9498 -18.4748 -15.0058 -11.9197 -4281 6 12.7366 28.0136 40.0786 16.9267 17.0007 -14.1953 -4282 4 12.7736 28.981 40.2539 2.04889 -13.1204 -10.7842 -4283 4 13.1752 27.8683 39.2015 -12.0592 5.90979 20.7524 -4284 6 50.5208 38.8121 28.4283 -2.96204 -29.3557 2.62021 -4285 4 51.1161 39.4306 28.008 -0.383593 20.3423 -2.32338 -4286 4 49.7133 39.2143 28.7877 7.69194 10.1621 -6.76025 -4287 6 33.551 8.21903 17.8634 -36.1599 -47.4859 45.2019 -4288 4 33.9333 8.85376 17.3385 32.2471 57.3944 -47.1321 -4289 4 33.8604 7.38657 17.5128 5.83122 -9.97324 -0.737685 -4290 6 34.648 34.7105 17.7828 9.01761 -19.7832 -8.77749 -4291 4 35.1788 35.3328 18.2888 -3.00831 8.66808 4.62333 -4292 4 35.2883 34.0014 17.5711 -12.5093 2.94991 -0.39307 -4293 6 40.7261 5.27864 23.3991 8.21105 0.19251 11.4926 -4294 4 41.4259 4.93717 23.9966 -11.2767 2.88733 -17.4667 -4295 4 40.0598 4.58084 23.2941 1.87831 5.06613 5.43463 -4296 6 16.9137 27.769 14.4809 73.6258 -34.7175 -8.82476 -4297 4 16.0667 28.1115 14.4612 -62.8462 32.6704 -2.60496 -4298 4 17.5486 28.5101 14.4313 -15.9271 -1.25076 7.8547 -4299 6 29.0219 14.6595 5.00786 20.8741 -13.5443 13.1138 -4300 4 29.536 13.8229 4.89138 -12.0375 16.0826 3.98067 -4301 4 28.8859 14.7576 5.97494 -2.91261 0.0620574 -16.4413 -4302 6 36.854 17.7325 5.08016 4.48522 -18.3735 -43.8449 -4303 4 36.2168 18.3553 5.39001 -11.7806 18.6728 17.0618 -4304 4 36.8305 17.8608 4.09391 11.7548 -5.76061 25.8999 -4305 6 27.7142 25.5094 34.8662 20.7401 -29.3529 -12.6468 -4306 4 28.3997 25.1535 35.4786 -13.7878 13.2187 -9.69645 -4307 4 27.3728 26.292 35.2699 -5.77421 14.8272 18.3022 -4308 6 24.7481 17.2805 18.0642 -3.31447 -10.4308 -2.46491 -4309 4 25.3087 17.9154 18.5049 2.27957 10.048 8.00722 -4310 4 24.0564 17.0505 18.7104 4.01172 4.3516 -6.8818 -4311 6 30.1789 1.58441 5.83411 4.12275 19.8646 -71.4749 -4312 4 29.4821 1.85802 6.42075 -6.9839 1.28517 8.89789 -4313 4 29.959 2.0434 4.91278 6.77151 -29.6581 61.3265 -4314 6 37.452 25.891 8.43789 -40.1641 -31.4732 50.6902 -4315 4 38.334 25.9927 8.78667 20.6785 -4.95116 -4.15592 -4316 4 36.9881 25.2791 9.14634 19.6253 32.8331 -49.0064 -4317 6 24.7604 7.00734 2.27008 32.0581 9.85747 -12.4546 -4318 4 25.4028 6.31463 2.48931 -5.40489 7.62931 7.6933 -4319 4 23.9158 6.58667 2.26874 -21.5893 -3.78057 4.11792 -4320 6 25.7887 38.8506 10.7619 -30.5475 28.1992 -59.3139 -4321 4 26.3103 38.4194 11.381 38.5207 -12.4255 48.7922 -4322 4 26.1525 39.7259 10.4932 -1.18865 -9.03037 15.3914 -4323 6 0.555207 13.578 28.1388 12.6332 42.7054 11.738 -4324 4 0.341766 12.7807 27.7179 -10.1825 -36.9478 -16.4943 -4325 4 0.413626 13.4435 29.0864 -5.17296 -1.28815 -2.85065 -4326 6 20.4105 17.1191 12.037 -17.9302 -38.4569 -26.5492 -4327 4 20.2295 17.2547 12.9605 -1.34068 5.07474 20.9983 -4328 4 19.8884 16.3005 11.7926 16.4515 20.0565 4.33162 -4329 6 30.9925 7.37797 16.6653 29.7996 22.3073 3.61878 -4330 4 31.2643 7.03844 15.7784 -2.63758 10.9944 17.123 -4331 4 31.7569 7.94595 17.0261 -27.6116 -29.8279 -14.8225 -4332 6 10.2093 5.78517 12.1714 32.5037 6.96704 58.397 -4333 4 10.1014 6.35617 11.4591 -8.08786 32.1119 -50.7901 -4334 4 9.65707 5.06197 12.024 -36.7963 -41.1043 -15.4671 -4335 6 18.4347 31.3493 24.155 3.48135 -6.25246 2.65688 -4336 4 18.4439 30.3878 24.2879 -2.95335 1.71216 0.944019 -4337 4 18.3198 31.7316 25.0273 -3.67252 2.09543 1.27238 -4338 6 27.8948 29.2525 29.2666 2.33504 21.8021 -21.5937 -4339 4 28.3627 29.5914 28.4251 -11.9103 -18.4763 37.4515 -4340 4 28.5196 28.9609 29.9463 14.9294 0.890267 -8.6061 -4341 6 38.3738 15.4456 29.791 12.9945 -28.6313 15.0543 -4342 4 38.0891 14.5036 30.0544 22.1369 39.5396 -7.74746 -4343 4 39.2957 15.632 30.1541 -37.4531 -3.97597 -10.3113 -4344 6 21.7041 34.7992 5.56934 -10.1436 -56.1371 25.2208 -4345 4 21.4621 33.8673 5.89439 16.7439 32.0975 -19.9868 -4346 4 20.9431 35.2741 5.907 -2.46203 13.3807 -4.97838 -4347 6 18.2064 16.8274 1.01093 1.02147 5.09087 9.91972 -4348 4 17.6405 17.264 0.353478 -0.489627 -6.58546 6.49815 -4349 4 17.8529 17.0628 1.89865 0.517006 0.361128 -13.8735 -4350 6 43.5166 18.4972 39.3436 16.5286 13.9247 -42.0759 -4351 4 43.0101 19.1966 39.7112 -21.9319 15.1254 24.622 -4352 4 43.7095 18.933 38.4597 1.00685 -29.3013 20.2287 -4353 6 17.7976 10.0688 35.5434 7.86102 19.599 -20.2005 -4354 4 17.8945 9.40709 36.2105 4.74187 -18.2058 11.3424 -4355 4 18.5459 9.97323 34.9151 -16.2901 -5.18221 9.2364 -4356 6 36.5889 30.5599 29.0828 -33.0481 48.6405 -12.465 -4357 4 36.5132 31.4977 28.7143 1.54088 -37.0728 8.50934 -4358 4 37.4982 30.324 28.9756 25.7485 -11.7594 -3.68806 -4359 6 38.4943 35.9682 10.4222 10.3079 16.2999 40.226 -4360 4 38.6552 36.6966 11.1228 -3.33458 -34.9071 -25.8136 -4361 4 38.3509 35.1294 10.9235 4.16648 17.1849 -3.98913 -4362 6 43.4036 18.8037 34.3607 -18.7725 -42.8138 41.3108 -4363 4 42.9709 18.1893 33.7432 11.3097 10.906 -2.86187 -4364 4 43.2777 18.3171 35.2411 6.94038 29.5352 -30.5758 -4365 6 11.0585 40.2128 6.10885 -15.7783 5.94868 1.16987 -4366 4 11.5965 40.9262 6.45194 10.3679 4.26541 4.32644 -4367 4 10.1443 40.5526 6.13585 6.40705 -5.05479 -5.29954 -4368 6 48.3342 13.7493 24.4707 -3.46168 30.4962 28.8754 -4369 4 47.8576 13.3588 23.754 -13.8134 -6.92474 -20.9085 -4370 4 47.8711 14.5963 24.7134 14.7345 -25.1065 -10.1999 -4371 6 1.47205 25.7712 23.7829 0.184952 23.7651 -2.41746 -4372 4 0.854396 26.4618 23.4919 -3.79407 -11.1699 -2.17794 -4373 4 2.13056 26.3319 24.2122 9.67536 -12.9921 7.11562 -4374 6 20.5856 0.045789 21.1048 4.96875 -22.7073 -7.43464 -4375 4 19.8117 0.249922 21.5931 -19.4423 21.7426 16.1957 -4376 4 20.4519 41.001 21.0443 13.8042 -0.350206 -3.82588 -4377 6 37.6675 12.896 30.7055 18.9575 -14.1068 -43.1025 -4378 4 37.1872 12.5493 29.907 3.14127 2.53034 24.3729 -4379 4 37.0391 13.1763 31.3358 -31.377 6.23238 20.3235 -4380 6 49.4665 17.3801 9.24655 -8.32961 25.946 -15.5009 -4381 4 48.5345 17.665 9.32633 16.3924 -11.5392 1.15372 -4382 4 49.8219 17.9883 8.54454 -1.98957 -21.6031 19.5257 -4383 6 34.3643 5.3502 17.1421 32.952 7.78829 -18.2658 -4384 4 34.6245 5.26975 16.1857 -14.4704 2.64329 20.4158 -4385 4 33.4298 5.20109 17.2262 -20.6176 -11.2241 -0.901893 -4386 6 14.7832 27.6655 0.085624 -10.3553 13.8949 -22.792 -4387 4 14.1034 27.8892 41.3249 2.03342 -11.2849 14.5146 -4388 4 15.1757 28.5319 0.287496 2.39463 -6.00136 9.68974 -4389 6 48.8635 15.5211 20.7504 -7.30397 3.37214 15.1279 -4390 4 49.1252 16.3754 20.4371 0.183023 13.7927 -3.76167 -4391 4 49.1585 14.9241 20.0762 3.93917 -17.6947 -14.7742 -4392 6 23.8074 40.3851 20.3877 -2.3041 21.5375 32.1864 -4393 4 23.5266 40.991 21.1382 8.45078 -18.9812 -28.3519 -4394 4 24.6929 40.0818 20.645 -4.8729 5.63426 -4.96266 -4395 6 35.18 31.4993 13.7142 -38.6695 32.0432 -41.3249 -4396 4 34.2219 31.3119 13.4889 30.0091 9.93153 3.95626 -4397 4 35.4367 30.7845 14.243 12.3636 -35.8089 30.5679 -4398 6 10.9775 9.01115 39.5206 -26.3812 35.8658 -19.2594 -4399 4 10.5557 9.91556 39.5205 15.5031 -28.3669 -8.85108 -4400 4 11.1542 8.87096 40.4393 5.31517 -3.54045 10.232 -4401 6 53.2061 4.88103 16.6049 -20.6689 -12.7794 3.6937 -4402 4 53.6782 5.3887 17.2239 33.7717 25.1716 19.5104 -4403 4 52.5676 4.51498 17.2255 -11.3933 -13.1169 -19.2452 -4404 6 7.83562 33.8039 26.1496 42.0062 50.3869 -17.047 -4405 4 7.62463 34.1533 27.0155 -6.33847 -9.39794 9.82588 -4406 4 8.42034 34.5749 25.7852 -30.6961 -50.8642 6.91563 -4407 6 31.3279 27.9472 6.28298 4.37835 -19.3247 -9.6219 -4408 4 31.922 27.5111 6.93657 -10.4846 5.09347 -11.9486 -4409 4 31.1129 27.3323 5.53276 6.79934 9.76999 15.6259 -4410 6 31.3655 2.17383 41.055 18.9421 -1.98994 34.5993 -4411 4 31.8109 2.17902 0.04034 -17.0754 7.04602 -28.7946 -4412 4 31.2404 1.23747 40.9086 -7.00813 -7.80206 -8.22245 -4413 6 33.7652 4.25739 35.9001 -31.2863 -13.3655 20.8802 -4414 4 34.2485 3.80076 36.6104 5.56552 8.36292 -9.80816 -4415 4 32.8077 4.13792 36.1863 30.7439 3.51509 -16.9094 -4416 6 47.9725 16.0636 29.8584 -12.289 -4.0311 -5.35812 -4417 4 48.7208 16.4163 30.3732 -4.13056 -10.8519 0.408936 -4418 4 47.3533 15.5947 30.4559 16.7379 8.85318 -0.563064 -4419 6 49.3385 10.0935 28.5885 -11.8118 4.56009 -13.0989 -4420 4 48.5886 10.6638 28.8239 3.51911 -4.5157 1.44109 -4421 4 49.3924 10.1159 27.6088 6.69909 -1.91925 15.8757 -4422 6 21.4187 27.7693 29.76 2.80336 -20.4787 -6.37736 -4423 4 21.861 27.2354 30.4624 -7.84738 15.6574 -13.8161 -4424 4 21.1828 28.6282 30.0799 2.10219 20.3695 17.9057 -4425 6 11.6757 39.482 25.8517 13.5538 20.9417 -1.29545 -4426 4 12.2965 38.7786 26.0889 -7.12508 -2.9493 -2.05027 -4427 4 10.8193 39.0846 25.7116 -11.9056 -6.20494 0.0112269 -4428 6 22.9798 39.311 7.85817 -12.7601 -4.86939 -3.04246 -4429 4 22.3059 38.6219 7.95844 1.92638 3.98273 0.136758 -4430 4 22.5772 40.0658 8.31757 9.04497 -1.85468 3.82529 -4431 6 42.5415 35.9278 31.3391 13.0935 -70.9729 -20.1514 -4432 4 42.6447 35.4696 30.4714 -5.52665 5.17936 25.8951 -4433 4 42.5102 36.7973 31.0384 -8.93799 60.9387 2.27408 -4434 6 33.663 14.7412 3.98499 30.4225 -17.693 -39.6888 -4435 4 32.8564 15.2185 4.09596 -24.3526 16.5192 2.50389 -4436 4 33.8944 14.7916 3.00116 -11.9532 1.40502 32.6284 -4437 6 36.697 8.6017 17.5153 18.7294 -29.9333 -4.55465 -4438 4 37.1702 7.95911 16.9159 -11.687 24.5338 13.7544 -4439 4 36.2734 9.25409 16.9543 -7.54123 3.80926 -6.08989 -4440 6 20.8295 32.4146 17.3309 -48.7404 -21.5825 11.0081 -4441 4 20.1664 32.9726 16.9048 10.2664 9.72211 -3.82622 -4442 4 20.2271 31.8015 17.8465 35.2036 12.7196 -8.50107 -4443 6 20.7003 35.3218 14.1083 -3.44914 -18.0461 -19.2112 -4444 4 21.3182 35.5386 13.4099 3.08163 2.90557 -13.4495 -4445 4 20.919 35.9437 14.7754 1.56244 13.5022 22.2067 -4446 6 20.2323 2.51936 40.1651 -9.22326 -14.3688 36.1644 -4447 4 19.7926 2.34354 41.0434 13.5524 6.30823 -28.5037 -4448 4 20.7516 1.7186 40.0171 -1.27786 1.50094 -7.75906 -4449 6 15.0477 14.4672 0.24789 12.9865 -5.55034 -72.7807 -4450 4 15.4827 13.6954 41.6877 -12.87 20.0829 29.6139 -4451 4 15.2186 15.2036 41.5094 -2.93016 -13.2387 23.097 -4452 6 24.8149 37.3373 18.5213 2.43631 -2.68492 27.9859 -4453 4 24.4361 37.9203 17.8611 -0.249038 9.91659 1.71419 -4454 4 24.5604 37.6468 19.4234 0.486379 -6.00228 -23.279 -4455 6 3.16989 27.7944 5.24229 1.80682 -16.6913 61.515 -4456 4 2.664 27.92 6.09489 -0.254446 2.50987 -32.3978 -4457 4 4.0252 27.4816 5.63916 -14.135 1.37322 -28.2843 -4458 6 37.1257 39.0598 36.0573 4.58816 40.5807 23.3296 -4459 4 37.5599 39.5885 36.7783 -22.7086 -1.13864 -22.8071 -4460 4 37.5439 38.2379 36.1828 13.5973 -37.3165 -5.96047 -4461 6 41.3477 16.3672 3.84024 25.8131 6.72768 37.2631 -4462 4 41.4431 17.3182 3.89206 -17.3786 8.01961 -13.1803 -4463 4 42.0046 16.1549 4.54461 -14.0821 -19.2698 -21.0799 -4464 6 15.5755 3.1684 35.3585 1.47298 2.70845 -61.2084 -4465 4 15.1145 3.59171 34.5864 10.479 -16.2188 17.3147 -4466 4 15.2032 3.60881 36.0782 -15.9672 22.7619 40.5269 -4467 6 33.1731 24.2438 7.96729 6.41569 -10.7526 14.1331 -4468 4 33.3408 24.6773 7.1445 11.9115 -7.07525 -26.7187 -4469 4 32.5824 24.8707 8.33408 -19.4303 14.6961 21.7816 -4470 6 35.865 29.7374 15.5979 -29.8607 35.3275 -32.1308 -4471 4 36.7747 29.6672 15.7703 43.701 -12.5229 16.5971 -4472 4 35.3562 29.0371 15.9739 2.56537 -15.478 18.0667 -4473 6 17.5843 36.8354 41.8728 12.1708 -5.57123 -52.5088 -4474 4 18.1833 36.773 0.675699 12.2604 -1.93512 36.5948 -4475 4 18.2359 36.8623 41.125 -21.8566 7.06165 11.6698 -4476 6 26.5622 4.14672 31.1307 -32.6289 -51.1506 -31.7953 -4477 4 27.2582 4.59627 31.5457 41.9615 24.0313 17.3243 -4478 4 26.8928 3.23766 30.8727 -4.86114 29.783 15.5489 -4479 6 31.9552 1.33198 34.4369 -14.3248 -8.90334 35.5546 -4480 4 32.7269 1.15305 34.9944 8.32726 6.02564 -17.2377 -4481 4 31.2642 1.08685 35.0838 -0.545778 4.81468 -20.3916 -4482 6 24.491 14.7534 2.38457 33.2042 -23.9469 17.2683 -4483 4 24.2753 13.9637 2.92779 -7.56186 18.0622 -11.5291 -4484 4 25.4626 14.8414 2.55985 -20.2114 8.54272 -9.97318 -4485 6 25.7566 20.9055 27.5389 -1.15091 7.1508 6.95521 -4486 4 25.459 20.6057 28.4261 8.17968 -1.38894 -17.9407 -4487 4 25.6371 21.8685 27.5748 1.97223 -1.15564 -2.97875 -4488 6 18.1445 40.1527 30.6395 17.3729 -20.3781 15.2884 -4489 4 18.5141 39.2638 30.8544 -10.5973 16.1604 -9.36512 -4490 4 18.9393 40.7073 30.6583 -6.94059 7.54086 -5.9327 -4491 6 46.7889 23.8914 24.5979 7.31075 41.4222 -46.8858 -4492 4 46.2898 24.602 24.0741 10.6002 -32.8666 22.2289 -4493 4 47.4121 23.5287 23.9473 -6.99108 -0.957122 4.26591 -4494 6 45.6201 22.6921 26.5067 -14.1777 -10.0967 -12.8229 -4495 4 46.0372 22.9342 25.6668 -2.41585 -1.26552 16.8561 -4496 4 46.0784 23.1676 27.2003 -0.61408 1.28207 1.11474 -4497 6 20.1006 4.48803 26.6974 -40.8522 40.1383 42.8029 -4498 4 20.2489 5.43817 26.4853 8.37449 -26.4011 -0.951475 -4499 4 20.6602 3.93368 26.2205 34.0606 -24.4352 -38.1565 -4500 6 35.278 26.5864 12.552 0.280065 20.4825 10.9931 -4501 4 35.6728 25.7022 12.4634 2.08478 13.3641 8.87461 -4502 4 35.7774 27.1222 13.2104 -5.20465 -19.6779 -15.4464 -4503 6 3.25879 33.9669 12.2907 -5.01808 -25.4739 5.3677 -4504 4 2.34263 33.6224 12.3201 4.20809 12.7539 -0.381501 -4505 4 3.26735 34.9165 12.3326 -4.58918 17.9212 0.78916 -4506 6 36.6873 1.27899 25.5756 -31.8717 2.25298 32.7844 -4507 4 37.6116 1.37326 25.7779 18.4499 5.6721 -4.77344 -4508 4 36.2122 1.51788 26.4163 6.97172 -2.04149 -25.7728 -4509 6 16.8705 4.65685 24.0413 -35.5309 2.76318 -23.9776 -4510 4 15.8575 4.70434 23.9217 47.0687 -0.0954558 1.21401 -4511 4 17.247 4.33879 23.186 -5.50277 -2.28941 17.9023 -4512 6 39.6565 15.0715 7.80572 25.6093 19.6796 32.1194 -4513 4 39.2854 14.2576 8.13712 -9.42359 -13.1845 -9.18942 -4514 4 39.3628 15.2517 6.91527 -5.26665 -12.4192 -5.15573 -4515 6 9.97948 20.1659 2.91877 -9.38613 14.9664 11.2777 -4516 4 9.63877 20.6452 2.15027 4.12295 -11.9706 -3.67253 -4517 4 9.85969 19.2106 2.80597 1.71997 13.0916 -4.74013 -4518 6 23.4135 4.6314 15.2717 1.19087 -47.3757 24.1847 -4519 4 23.6596 4.57091 14.3636 3.27412 12.4021 -25.8415 -4520 4 23.0767 5.481 15.4712 -5.64379 31.4202 -0.243197 -4521 6 23.5143 41.6409 17.9193 15.1077 8.25095 -6.6202 -4522 4 23.8837 41.2632 18.7444 -17.9015 4.85421 -1.14363 -4523 4 22.6477 0.129763 18.1032 2.89941 -5.9973 3.37217 -4524 6 30.9257 4.8197 1.33225 52.4556 82.2644 21.8498 -4525 4 30.6067 4.04082 1.0087 -28.5575 -73.6424 -29.1188 -4526 4 31.8008 4.99709 0.898826 -20.2281 -12.9509 7.44496 -4527 6 29.2107 33.7595 18.6102 73.0072 -21.2941 -2.29721 -4528 4 30.2072 34.0216 18.5444 -47.9733 -6.17517 5.28057 -4529 4 28.7323 34.5281 18.37 -21.0864 31.3556 1.11974 -4530 6 23.1159 16.7161 3.6681 15.0693 -22.2232 4.2808 -4531 4 23.7494 16.3853 2.99745 -15.1451 3.0429 8.25243 -4532 4 23.0882 17.666 3.59926 -2.15966 11.8771 -4.335 -4533 6 34.9011 26.7664 31.7501 -1.76717 8.52767 -40.8429 -4534 4 35.037 27.6398 31.3273 1.29043 -2.59798 26.5044 -4535 4 34.999 26.223 30.9552 -0.698038 -3.54606 8.98008 -4536 6 7.10213 40.7731 20.9713 24.4432 1.2064 -5.23395 -4537 4 6.57619 40.3882 20.2802 -20.054 -4.79313 -9.64846 -4538 4 7.95521 40.8692 20.51 0.818491 4.17448 7.60026 -4539 6 52.4557 9.69054 11.9333 -13.8891 -19.4181 -13.3487 -4540 4 52.1298 8.88818 11.4535 9.48574 25.0976 13.8313 -4541 4 53.1611 10.0725 11.3936 -7.122 -1.8527 1.23238 -4542 6 12.0235 32.7598 27.7442 3.70099 -7.78602 -3.89203 -4543 4 11.3626 32.1501 27.3892 -5.86407 9.3821 3.02313 -4544 4 12.7405 32.6461 27.1218 9.18069 3.19616 2.31322 -4545 6 15.7918 18.546 0.850378 10.8461 -1.95532 -11.5883 -4546 4 16.438 18.9813 1.41668 1.29405 -2.87095 0.147979 -4547 4 14.9753 18.6242 1.3119 -21.1882 -0.0291689 9.92309 -4548 6 30.9967 13.9378 7.42939 11.475 1.61738 -44.5395 -4549 4 31.0432 13.5913 6.48715 -7.7997 1.97415 36.5778 -4550 4 31.6719 14.6391 7.43931 -7.46887 -7.66354 10.6483 -4551 6 23.9383 39.564 3.55488 34.3001 -22.0749 -10.0269 -4552 4 24.3437 38.8163 4.07249 -17.2972 16.8542 -11.2744 -4553 4 24.6493 39.7352 2.88999 -19.8697 7.819 10.5959 -4554 6 53.2452 13.9576 2.00229 -14.7116 -5.90049 -8.44118 -4555 4 54.0493 14.3984 2.24709 19.6807 0.169927 9.22775 -4556 4 52.9645 14.4205 1.20429 2.95034 -7.59818 -1.70329 -4557 6 29.4557 26.4275 7.80964 12.1022 6.02758 -9.79702 -4558 4 29.9353 26.7368 7.00545 -17.6775 -4.91001 19.2628 -4559 4 28.525 26.2807 7.58748 -5.08244 6.84096 -3.37299 -4560 6 24.6247 23.6022 31.0889 -22.8452 23.3962 -39.3716 -4561 4 23.7242 23.1866 30.9343 31.0198 16.8155 5.56769 -4562 4 24.7802 24.3072 30.3632 -7.32447 -41.3429 34.091 -4563 6 33.6649 19.3163 40.5091 -6.65541 -1.27585 7.81728 -4564 4 33.8354 18.657 41.2044 -1.67667 1.74775 -3.87809 -4565 4 34.3105 19.1562 39.8145 2.0445 4.20075 -4.1701 -4566 6 0.559384 35.9874 14.2134 5.8565 -19.6842 -1.82955 -4567 4 1.23941 35.9463 14.8996 -3.202 15.0395 2.84586 -4568 4 0.030681 36.7785 14.2979 -4.01885 14.7851 6.49139 -4569 6 7.05661 12.759 15.7779 -22.8667 -6.52104 17.6379 -4570 4 6.34583 12.5966 16.4564 20.9558 0.33122 -21.552 -4571 4 6.91757 12.0848 15.0954 -2.34629 3.44815 6.08752 -4572 6 7.88282 3.87818 22.4173 5.89555 -44.5054 15.1514 -4573 4 7.49019 4.56914 21.9267 -7.80716 26.896 -25.5563 -4574 4 7.61791 3.03791 21.9647 5.08594 18.6769 15.1101 -4575 6 50.7471 32.0888 16.2401 1.83727 42.1646 -7.06137 -4576 4 49.8752 31.8312 16.5285 -7.29916 -4.21179 -0.512004 -4577 4 50.6362 33.057 15.9791 5.96194 -37.4522 8.78354 -4578 6 15.303 18.2089 30.059 10.7923 -22.0796 25.2673 -4579 4 14.9011 18.5061 29.2675 -14.0638 14.0876 -27.3921 -4580 4 14.9173 17.3208 30.1974 9.34767 8.93092 3.04247 -4581 6 36.7231 25.4597 33.3812 -54.2725 16.2506 -34.9161 -4582 4 35.9173 25.838 32.8237 55.5216 -11.0114 39.6871 -4583 4 36.747 24.5432 33.1027 5.79642 -6.85026 5.14009 -4584 6 16.5358 21.8507 20.2615 -17.2006 3.10996 -10.5852 -4585 4 16.5318 20.9271 19.9881 4.62491 -6.39719 -1.16283 -4586 4 16.2171 22.3466 19.4835 8.40466 -0.269645 8.83911 -4587 6 44.2784 3.11614 30.075 -4.29151 -10.9085 31.9498 -4588 4 44.2908 2.23086 29.7056 -5.3385 -9.83615 -1.81045 -4589 4 44.5205 3.68982 29.3775 9.49019 22.102 -29.428 -4590 6 51.0822 14.1295 27.7742 -18.732 -33.3382 -1.30318 -4591 4 51.215 15.0658 27.7997 -1.99026 24.8352 -0.164216 -4592 4 50.1181 13.9695 27.6298 18.0185 9.91077 0.913588 -4593 6 54.1414 15.8836 27.1251 18.1892 -50.717 -21.9912 -4594 4 54.5758 14.9905 27.2793 -7.90108 34.3346 13.352 -4595 4 53.8259 15.7459 26.2068 -12.5208 17.6482 15.4671 -4596 6 26.7107 15.1629 34.529 26.3006 32.6175 -12.2305 -4597 4 26.7089 16.144 34.4655 -8.86078 -18.0829 7.52702 -4598 4 27.5163 14.9973 34.009 -10.4907 -11.0891 -0.654257 -4599 6 34.6699 2.22267 27.4725 27.1341 -12.2799 29.337 -4600 4 34.3153 1.93716 28.3227 7.08088 3.88889 7.09202 -4601 4 33.8991 2.25298 26.9555 -28.541 9.30381 -28.496 -4602 6 36.3083 17.6409 40.3953 7.68303 1.60807 9.57574 -4603 4 35.716 17.1791 39.8253 -12.5236 -4.37947 -14.4862 -4604 4 36.6569 16.9265 40.9504 1.18426 15.263 2.6664 -4605 6 26.2972 0.194896 33.0957 0.945324 -1.75644 -10.1569 -4606 4 26.0926 0.771392 33.8475 -8.68516 2.0119 1.91424 -4607 4 25.4691 41.6865 32.8295 -8.00507 -1.67316 12.192 -4608 6 5.19113 35.5773 31.6357 23.2413 -27.7984 27.0466 -4609 4 6.1476 35.7159 31.7435 -10.1506 4.22761 6.12862 -4610 4 4.96861 36.095 30.8978 -11.7512 22.2076 -38.0194 -4611 6 20.2191 22.0354 35.1304 9.30742 -6.19625 19.4235 -4612 4 19.9844 21.2003 34.7289 -5.16022 -6.81034 -3.33987 -4613 4 20.4782 21.7596 36.0473 -3.02096 9.85719 -25.9724 -4614 6 15.9251 36.5949 36.947 -9.13121 -30.7472 31.1466 -4615 4 16.4837 37.3712 37.0549 6.13876 -3.03661 -2.05614 -4616 4 16.031 36.0658 37.8159 -5.1453 16.1721 -39.9007 -4617 6 30.9484 22.4015 3.56131 11.993 -60.8988 -15.4947 -4618 4 31.1008 22.6958 4.44557 1.55935 5.74187 27.4751 -4619 4 31.2551 21.4217 3.58407 -13.4398 43.4536 -6.61432 -4620 6 47.0429 8.40936 14.2086 -4.42011 -15.6298 -34.0486 -4621 4 46.2603 8.29509 13.606 17.325 5.05196 18.7602 -4622 4 47.7698 7.89697 13.7682 -18.8904 11.0332 12.0247 -4623 6 34.1011 18.6159 3.148 0.361877 23.965 35.4915 -4624 4 34.6363 18.3397 3.89922 -0.845538 -0.743075 -4.07575 -4625 4 34.3812 18.1265 2.40098 2.04544 -17.9565 -29.3984 -4626 6 26.7996 25.3961 12.3408 -30.8906 -54.2954 26.5725 -4627 4 27.3117 26.1608 12.4557 20.536 44.4803 3.39785 -4628 4 26.6414 25.0259 13.2528 6.28377 9.49183 -30.6151 -4629 6 22.6108 25.7845 30.8845 17.3255 -0.303924 3.7754 -4630 4 23.4288 25.6954 31.4132 -11.344 -1.13015 -1.03332 -4631 4 22.2314 24.9052 30.7722 1.09512 -5.6623 7.4309 -4632 6 23.6311 9.76276 35.7585 -2.90797 -4.19552 -4.78319 -4633 4 22.8314 10.2832 35.6581 -5.74139 5.63622 4.02691 -4634 4 23.3139 8.86685 35.4998 11.2809 19.0625 6.63709 -4635 6 10.4076 36.7742 9.64242 -28.436 -9.9846 9.32351 -4636 4 9.50067 36.3875 9.59353 19.7531 11.7612 -0.53903 -4637 4 10.7226 36.8301 8.7426 3.69205 5.92187 -13.8772 -4638 6 4.00038 32.4265 25.8669 22.0714 10.4661 11.4497 -4639 4 4.38844 32.9375 25.1422 -1.34031 3.54398 1.69886 -4640 4 3.2706 31.9516 25.4996 -17.8371 -17.4963 -10.4987 -4641 6 29.085 26.0296 18.6527 19.273 -47.5776 11.2122 -4642 4 28.2115 26.0231 19.0264 -21.1607 3.13806 -0.423844 -4643 4 29.4632 25.1291 18.9323 -7.10954 42.4601 -14.5827 -4644 6 15.3089 1.3255 27.9792 -24.1234 20.5069 -17.5654 -4645 4 15.0496 0.974163 27.1169 2.04641 -4.01433 11.5068 -4646 4 14.7355 2.12388 28.0804 19.9995 -12.8223 4.08523 -4647 6 48.6106 2.88816 22.9655 -1.26722 3.55247 -0.201848 -4648 4 48.4165 2.02818 22.6182 -14.5439 -12.5884 3.03438 -4649 4 49.5001 2.98572 22.6432 10.4652 10.9023 -5.33271 -4650 6 53.0075 0.36099 19.7296 11.424 -8.43987 -8.95848 -4651 4 52.5965 41.9022 20.5162 -3.41206 4.78179 6.33318 -4652 4 52.3731 0.223553 19.0136 -6.83989 5.16364 0.289704 -4653 6 1.41074 17.5036 17.9462 -15.7932 -16.9445 -5.36496 -4654 4 1.29993 17.3585 17.0019 -2.92928 12.5396 -5.88676 -4655 4 1.38271 16.6004 18.2823 6.65411 -3.00458 14.0519 -4656 6 37.9084 19.0323 37.6056 -38.9323 8.68785 -13.5971 -4657 4 36.9858 18.7285 37.7384 11.3307 8.89304 -0.372118 -4658 4 38.4207 18.4342 38.1195 19.3518 -17.7067 16.118 -4659 6 26.9813 30.3571 38.0896 -0.527767 18.5171 -30.3811 -4660 4 26.1212 30.285 37.6565 1.23907 -9.17466 9.80696 -4661 4 27.2764 31.2069 37.701 2.1524 -13.2267 12.8694 -4662 6 20.0955 18.5722 3.03696 10.9017 21.9571 9.92937 -4663 4 20.0263 17.806 3.59422 -10.4522 -23.2015 2.62566 -4664 4 20.8322 19.0363 3.46766 -4.52129 0.073665 -16.3651 -4665 6 35.0841 6.94694 4.08385 8.40312 -14.6319 10.4582 -4666 4 35.6826 7.16069 3.3578 -1.64356 4.34706 -6.00978 -4667 4 34.2613 7.42764 3.99145 -7.61312 4.93718 -6.31016 -4668 6 22.2176 37.0878 31.2599 -35.8324 13.882 69.7054 -4669 4 22.1593 36.8558 30.3798 -4.04212 -13.8909 -61.3413 -4670 4 21.2552 37.1952 31.5589 44.4461 1.84169 -14.4682 -4671 6 12.3904 22.3711 41.8265 33.9103 21.3816 -17.5574 -4672 4 13.0623 23.0096 41.4404 -31.3175 -17.017 24.3472 -4673 4 11.7392 22.2302 41.1411 -5.71588 1.3909 -0.895108 -4674 6 43.2333 30.3145 23.1566 26.412 30.0652 1.94466 -4675 4 44.1443 29.9954 22.911 -23.9673 11.2944 4.28313 -4676 4 43.3588 31.2906 23.3811 -4.98348 -33.6726 -4.24118 -4677 6 16.5316 8.07904 16.6592 -13.1305 -2.58289 1.30551 -4678 4 16.426 8.46358 15.7881 -7.07274 -4.02537 -8.52635 -4679 4 17.4421 8.27811 16.8595 11.8389 2.77268 11.6749 -4680 6 10.0527 8.64979 31.7837 -8.97334 17.7557 -57.5223 -4681 4 10.1312 7.90747 32.3291 5.58005 -27.1767 37.8097 -4682 4 10.1183 9.47003 32.2578 1.92783 9.29621 23.4619 -4683 6 10.1389 6.52097 25.6279 25.2027 -9.57639 0.964906 -4684 4 9.42987 6.19895 26.1639 -19.2857 -8.54063 7.31181 -4685 4 9.7626 7.17299 25.0306 4.07146 -2.80849 4.96109 -4686 6 49.8614 7.23714 25.5252 -17.9172 7.62946 -5.56104 -4687 4 50.0467 6.31121 25.4422 2.69032 -18.6529 -6.42341 -4688 4 50.6907 7.63095 25.75 18.9978 12.6416 8.6826 -4689 6 18.4677 37.5766 33.9365 -27.5019 7.45217 1.11424 -4690 4 17.6855 38.1606 34.0956 24.1544 -3.52274 -4.16364 -4691 4 18.0518 36.7105 34.0373 4.53854 -5.63623 -1.47673 -4692 6 32.1991 34.7999 39.2511 37.7035 -28.7103 22.0041 -4693 4 32.3976 34.2973 40.087 0.14143 15.1618 -21.7552 -4694 4 31.3182 35.0784 39.3573 -42.2601 10.9481 4.26487 -4695 6 49.5371 23.9083 4.45427 26.1113 1.30104 -36.4507 -4696 4 49.7626 23.2251 5.06121 8.22711 -23.3511 16.8473 -4697 4 48.7895 24.3154 4.8182 -37.5883 23.1909 21.4935 -4698 6 6.05615 24.4755 33.9372 -3.62864 21.1406 1.2609 -4699 4 6.78781 23.8493 33.8811 -5.98028 -5.90455 -1.42734 -4700 4 5.44033 24.2071 34.6424 10.5748 -4.32926 -7.84557 -4701 6 1.71417 22.9797 24.1919 12.9465 25.751 -13.942 -4702 4 1.74027 23.9063 23.8744 -7.21984 -9.04225 7.93975 -4703 4 0.785802 22.7901 24.3299 -10.4675 -5.82386 8.34916 -4704 6 12.4544 16.5695 32.338 -33.1179 2.9171 31.5337 -4705 4 13.1434 15.995 32.5512 52.391 -27.2499 -12.3732 -4706 4 11.9701 16.4097 33.1768 -13.251 25.8897 -21.4653 -4707 6 21.3776 37.3784 27.9508 -6.73969 12.2577 23.3137 -4708 4 21.2203 37.3231 27.0262 1.16773 -1.52428 -34.5533 -4709 4 20.718 38.0458 28.2038 6.71566 -1.73666 8.03222 -4710 6 27.2299 40.8388 28.8031 2.48401 0.937021 1.60569 -4711 4 26.5367 41.5089 28.9565 6.65702 -12.2841 2.86921 -4712 4 27.4065 40.3185 29.6035 -12.9999 8.55112 -0.224288 -4713 6 0.993205 21.7261 13.5372 -53.3037 2.48171 -36.3839 -4714 4 1.86429 21.8093 13.8237 52.7771 -6.56786 29.3883 -4715 4 0.417346 21.4203 14.2472 8.63216 3.11646 10.526 -4716 6 22.3067 2.58146 8.73662 29.448 -13.2509 35.6107 -4717 4 22.9722 3.05705 8.24165 5.16658 9.50374 -8.2335 -4718 4 21.5154 2.5876 8.23764 -24.8297 4.23497 -21.3736 -4719 6 29.9953 17.8456 8.24313 -2.433 8.62767 -9.90081 -4720 4 29.054 17.6713 8.30654 -5.44558 -4.70631 2.21427 -4721 4 30.3746 17.4275 9.01982 5.69521 -3.15286 8.62416 -4722 6 3.62819 37.7118 25.7099 -17.1271 -24.8271 -10.3244 -4723 4 4.40422 37.1524 25.7956 9.9921 4.76654 4.66524 -4724 4 2.941 37.0477 25.4485 4.12723 25.8155 6.09629 -4725 6 26.809 27.648 36.3589 -37.7802 -17.2474 29.8166 -4726 4 26.8014 28.1831 35.5758 -1.13827 16.217 -13.4241 -4727 4 25.8725 27.5642 36.7259 28.3017 7.35189 -21.1707 -4728 6 13.3559 25.3099 38.116 1.93465 -14.8526 16.0582 -4729 4 13.2959 24.3789 38.4372 3.98877 20.6101 -4.99041 -4730 4 14.1146 25.694 38.605 -5.66874 -3.07699 -9.11419 -4731 6 49.7048 27.2599 6.72622 -1.43928 22.3256 -10.7839 -4732 4 49.6686 26.3369 6.45132 -5.99645 4.70457 -4.8273 -4733 4 49.2845 27.8697 6.04945 8.54794 -27.7312 19.0533 -4734 6 39.7449 11.5776 10.1987 6.84991 -8.95817 -1.04181 -4735 4 40.3059 10.8428 9.86803 -8.86198 19.4731 1.33094 -4736 4 39.0907 11.7833 9.50723 6.52335 -1.56097 1.75374 -4737 6 17.4857 24.9907 35.5559 -11.6728 -0.232318 -1.23817 -4738 4 17.2359 24.7743 34.6481 -9.71541 0.96097 3.2925 -4739 4 18.4326 24.9281 35.5495 18.729 -4.76527 0.24637 -4740 6 45.0886 34.9858 31.8393 -13.7853 -2.59791 -12.3576 -4741 4 44.2542 35.4282 32.0247 4.31579 11.0194 10.5125 -4742 4 44.8031 34.4855 31.0733 13.3341 -13.9746 -4.20839 -4743 6 30.2109 9.89077 31.3202 8.39813 20.0527 10.0978 -4744 4 30.4343 10.7522 30.9233 -1.69236 -11.2354 5.34707 -4745 4 30.0976 10.0887 32.2697 2.61193 -8.5831 -6.90929 -4746 6 32.3748 9.22464 6.61109 37.8815 -39.2378 -50.8405 -4747 4 32.2118 8.68084 5.76454 4.57858 20.451 35.1159 -4748 4 31.5433 9.4233 6.96427 -45.6188 15.529 19.6617 -4749 6 9.26845 24.9782 35.9229 1.19564 -9.02769 -15.4958 -4750 4 8.9564 25.4582 35.1216 5.49795 -4.99978 19.1154 -4751 4 9.87718 25.5584 36.4061 -8.42028 -2.10732 -11.5846 -4752 6 40.3335 1.48296 18.8902 20.9136 0.652934 -58.3414 -4753 4 39.6207 1.94237 19.2768 -32.228 11.5513 31.9135 -4754 4 40.836 0.952532 19.4949 5.43911 -12.9068 21.333 -4755 6 5.27733 10.6166 30.4293 -4.37857 29.6514 35.8012 -4756 4 5.00531 11.4476 30.0112 -0.880507 -1.63534 -8.13264 -4757 4 5.35863 10.9185 31.3957 -0.759826 -20.4729 -25.7258 -4758 6 25.6655 11.6994 25.6535 -15.8411 -39.3949 6.40341 -4759 4 25.8392 12.448 26.1908 9.94197 23.9877 11.5846 -4760 4 25.8146 10.9427 26.2759 4.01869 23.17 -23.7809 -4761 6 21.9208 20.0736 29.783 -0.661059 -23.1285 25.9828 -4762 4 22.5528 19.9674 30.5279 -9.0028 12.6586 -11.845 -4763 4 21.4796 19.2024 29.7633 3.30396 8.80601 -15.8778 -4764 6 10.0031 19.9894 34.5062 10.0701 -18.9504 -1.84201 -4765 4 9.43917 20.4787 35.093 -9.85162 7.82768 6.06887 -4766 4 9.97528 19.0642 34.823 3.96148 11.1077 -9.79004 -4767 6 24.6395 10.3611 12.2013 10.4056 19.7725 40.7349 -4768 4 24.7062 9.53294 12.699 -2.91134 1.50973 -12.3578 -4769 4 25.0089 11.0108 12.8733 -15.5791 -20.8054 -25.2752 -4770 6 50.4386 28.2959 11.551 52.3964 -11.4141 -41.8896 -4771 4 51.2944 28.7096 11.1811 -37.3824 -15.4271 20.8858 -4772 4 50.1484 28.8694 12.238 -9.02874 19.1251 18.783 -4773 6 13.9255 27.6321 25.0575 -30.7043 9.27758 -16.9407 -4774 4 13.4685 27.961 25.8505 6.53671 1.50814 -8.33226 -4775 4 13.405 28.0084 24.2853 19.6442 -13.6277 24.9436 -4776 6 46.1675 18.6723 40.4127 -24.7255 0.52235 -5.51451 -4777 4 45.2163 18.6287 40.1471 17.8616 -3.70574 0.193046 -4778 4 46.2526 19.5549 40.792 -2.63441 -2.56699 -8.45512 -4779 6 32.4875 14.1744 27.1342 -20.1773 -0.115465 -0.458595 -4780 4 31.894 13.6021 27.6676 10.0212 10.5514 -7.27374 -4781 4 32.1329 15.0809 27.2203 4.74838 -8.22403 2.71507 -4782 6 14.0641 36.351 13.3878 -9.69625 43.6715 -7.48797 -4783 4 14.0645 37.3444 13.3555 12.262 -25.9465 20.9036 -4784 4 13.2835 36.2347 12.8457 -5.28255 -22.0231 -7.64651 -4785 6 1.89477 36.5899 21.9857 -12.7075 -7.68583 0.53673 -4786 4 1.75133 36.5712 22.9388 2.01013 -3.06644 8.01032 -4787 4 2.81569 36.8315 21.8421 3.36212 -1.19737 0.805445 -4788 6 25.2943 31.8607 39.7417 -2.48011 0.614033 34.0265 -4789 4 24.999 32.7283 39.4716 -5.73903 6.77443 -6.35095 -4790 4 25.461 31.9431 40.7124 0.191009 -4.33082 -23.8473 -4791 6 6.4797 22.0186 1.29894 -12.0535 -14.7769 -6.17691 -4792 4 5.53353 21.8063 1.36197 11.0348 5.26157 5.70773 -4793 4 6.5732 22.8347 0.80957 1.58971 11.8894 0.78955 -4794 6 27.6266 25.0275 4.69979 7.76412 30.8855 29.066 -4795 4 28.5017 25.4862 4.66738 -16.9061 -15.4428 -5.02391 -4796 4 27.2115 25.3905 5.52919 8.95609 -10.8934 -21.2922 -4797 6 21.6474 30.9429 41.2213 -14.674 16.9935 -31.5335 -4798 4 21.3077 30.3434 41.8509 -10.7705 -24.5884 29.0962 -4799 4 20.9035 30.9616 40.5667 22.5963 5.39714 5.21952 -4800 6 32.3503 18.8691 12.7728 -7.52429 -0.383917 -18.241 -4801 4 31.3918 18.9773 12.8161 6.27066 1.36054 6.85895 -4802 4 32.4619 18.5656 11.8564 12.6246 0.663961 8.91714 -4803 6 35.6352 19.4593 21.1461 -10.1734 29.4522 17.7801 -4804 4 35.3511 18.62 21.5049 -2.07097 -11.6796 -4.30053 -4805 4 34.9906 20.1214 21.5255 16.9121 -20.2959 -15.2058 -4806 6 27.6974 17.9478 34.0105 3.72497 22.7808 11.4532 -4807 4 28.1244 18.3695 33.2449 -3.6365 -3.33971 3.70746 -4808 4 28.0134 18.5196 34.7467 -3.33496 -14.4526 -11.1074 -4809 6 34.1722 39.0415 14.8025 -0.588556 -5.09353 50.87 -4810 4 33.8492 38.3378 14.2426 -9.69809 -4.78927 -2.35124 -4811 4 33.6075 39.0103 15.6476 14.9636 10.6202 -38.8415 -4812 6 28.5063 3.47722 33.8826 -13.8698 -21.2799 4.06498 -4813 4 27.871 4.20321 33.9085 6.20243 8.28698 -1.91661 -4814 4 29.4175 3.76621 33.9059 10.9167 16.0273 -3.84391 -4815 6 34.9231 32.1486 6.55347 -48.5451 -22.9266 3.43697 -4816 4 33.9921 31.9748 6.9467 49.872 11.9331 -17.2337 -4817 4 35.5478 32.1135 7.28146 1.17984 3.66225 6.53991 -4818 6 31.8923 6.87344 23.517 2.73099 13.3553 4.48118 -4819 4 32.4005 6.72509 22.7097 -0.163961 -9.68163 3.8586 -4820 4 32.2042 7.75277 23.812 -2.19309 -5.80853 -1.60196 -4821 6 18.8495 1.74691 0.846251 -10.8424 6.73855 -33.2301 -4822 4 18.128 2.12906 0.287715 7.30697 -5.37966 19.0723 -4823 4 19.1812 2.42034 1.43504 -3.90896 9.02122 12.2654 -4824 6 27.0029 18.9235 11.8738 61.7268 20.0146 -35.0636 -4825 4 27.2277 19.7644 11.4142 7.64396 -16.2258 9.71345 -4826 4 26.1059 19.0334 11.9849 -72.3018 -1.47246 20.779 -4827 6 43.8315 11.1413 18.4425 12.0955 7.77381 31.2403 -4828 4 43.582 10.9955 17.5403 1.6883 -14.8273 -19.2234 -4829 4 44.4878 10.475 18.7348 -4.89818 7.49251 -15.5557 -4830 6 33.4942 40.5585 37.6724 7.87983 -3.11064 16.6213 -4831 4 33.9456 40.2455 38.4765 5.57637 6.44045 -9.71494 -4832 4 32.6057 40.2384 37.8499 -11.5443 1.61602 -9.31227 -4833 6 15.6218 26.7049 39.4143 -33.8245 -53.4627 11.7102 -4834 4 15.4245 26.9754 40.2985 -0.693124 5.44593 20.3253 -4835 4 16.1216 27.3809 39.0562 36.6223 43.7441 -31.7418 -4836 6 4.38199 13.876 40.8778 6.07973 -11.0772 -3.70535 -4837 4 5.33347 13.6897 41.0138 -14.6737 -0.272428 -1.39073 -4838 4 4.02273 13.2235 40.2449 7.64869 11.7946 8.98025 -4839 6 20.1779 10.396 38.2135 -21.4206 4.43784 1.78325 -4840 4 20.3564 10.9148 37.4134 10.9013 -11.3706 0.559506 -4841 4 20.991 10.2443 38.6984 6.99273 1.77474 -1.94206 -4842 6 15.1578 19.2491 23.8705 6.70925 0.197906 -4.49513 -4843 4 15.3523 20.1614 24.134 -1.79925 -4.44488 8.10361 -4844 4 15.0598 19.3463 22.9079 -1.20619 -5.61783 14.9214 -4845 6 47.881 28.6148 15.8048 16.8356 22.7469 11.8397 -4846 4 48.0602 27.74 15.4965 -2.52866 -23.0751 -5.40804 -4847 4 48.6281 28.8091 16.402 -10.5906 -5.01786 -6.93826 -4848 6 29.925 30.905 18.9707 11.7406 3.33263 -1.10353 -4849 4 29.0879 30.4807 18.764 -8.84985 -7.33813 -1.92291 -4850 4 29.807 31.8375 18.7873 -6.04184 4.11832 2.37084 -4851 6 11.9324 35.8064 28.512 -27.4265 24.0258 -21.7564 -4852 4 12.5706 36.1347 29.1334 15.2736 -4.81493 21.8335 -4853 4 12.2236 34.9831 28.145 8.79196 -20.6768 -0.490374 -4854 6 29.967 37.8624 25.4885 4.59009 -4.14727 -0.313094 -4855 4 30.2605 37.0012 25.8228 -4.78695 -0.224547 -14.1967 -4856 4 30.4431 38.4647 26.0537 0.190265 15.5785 7.27405 -4857 6 52.6385 28.1101 32.2696 27.4129 -14.0906 14.429 -4858 4 52.1837 28.8064 31.8018 1.35463 13.918 -3.63194 -4859 4 53.5572 28.4115 32.4361 -8.8806 -0.527566 -10.0859 -4860 6 37.0194 40.0856 11.9811 12.8522 -14.0915 -8.99985 -4861 4 36.2698 40.6335 12.1547 -20.3135 9.86443 5.11387 -4862 4 37.3206 39.8255 12.8594 7.06858 1.59634 4.17732 -4863 6 16.6823 16.7862 36.5016 -40.0159 24.4695 -22.7659 -4864 4 15.9639 17.4464 36.7433 30.1481 -22.6997 -3.51596 -4865 4 16.709 16.8774 35.5181 2.88256 -1.64708 20.873 -4866 6 28.0056 4.17661 38.8341 -15.1907 4.44859 15.1459 -4867 4 28.8664 4.34511 39.2253 10.7528 -1.70638 -4.98709 -4868 4 28.1362 3.72531 37.9969 -2.54795 -6.06729 -7.91519 -4869 6 28.9121 0.2613 17.7196 11.2429 43.6022 -6.13696 -4870 4 28.206 0.913023 17.5432 1.57334 -10.0134 0.986336 -4871 4 28.5175 41.3357 17.883 -22.7122 -29.353 3.51833 -4872 6 22.9275 20.1119 26.272 10.3141 -17.1908 1.54721 -4873 4 23.597 20.0083 26.9758 -6.33812 5.26805 -6.32666 -4874 4 22.343 20.8217 26.5441 4.5912 8.26641 6.04785 -4875 6 49.4104 29.8887 13.4211 -27.0365 40.5227 7.20695 -4876 4 49.0994 30.824 13.2506 14.963 -27.7355 -0.582388 -4877 4 48.6865 29.5209 13.9525 8.18699 -4.12202 2.86767 -4878 6 2.45827 24.8307 7.29137 -22.8365 1.45709 37.207 -4879 4 2.32025 24.5445 8.23446 11.0976 11.5137 -22.649 -4880 4 1.77037 25.516 7.1857 7.09177 -11.7652 -6.70138 -4881 6 30.3948 26.4611 14.3404 -21.8067 20.3233 2.80707 -4882 4 31.1122 26.3224 14.9982 -12.4575 10.0222 -1.69757 -4883 4 29.8137 27.2743 14.5309 34.7851 -33.9666 2.2264 -4884 6 27.0321 32.5068 3.14827 -14.3662 17.1598 1.60641 -4885 4 26.4039 33.1156 3.62616 22.1531 -16.0826 -13.2832 -4886 4 27.3831 31.9163 3.82559 -1.71579 -4.01879 3.19031 -4887 6 34.2634 14.7959 1.27313 2.99828 -7.05923 -10.0889 -4888 4 35.1835 14.4352 1.19997 -20.4533 4.23129 -4.55267 -4889 4 33.713 14.3258 0.588346 24.9828 8.52884 21.9593 -4890 6 30.022 8.54163 1.32868 -10.2939 -13.069 16.6852 -4891 4 30.0052 9.45247 1.0409 -5.08902 11.4157 2.73646 -4892 4 29.2496 8.43498 1.92915 15.9692 5.13326 -10.6744 -4893 6 42.5647 11.5185 27.7103 -4.68909 6.08661 -3.61857 -4894 4 42.216 12.3928 27.8946 9.09127 8.642 -2.18095 -4895 4 41.8714 10.9656 28.0604 -6.00702 -16.6262 4.78299 -4896 6 52.461 39.5492 17.8365 12.2605 -26.0754 -32.0817 -4897 4 51.7553 39.7908 18.3861 -39.7898 9.50592 28.6027 -4898 4 53.1226 40.1801 18.0155 30.5873 23.5517 5.0779 -4899 6 33.2136 4.91918 31.6183 -6.56942 36.6821 16.923 -4900 4 32.9061 5.86322 31.5606 3.78329 -26.1329 5.01225 -4901 4 32.8884 4.48208 30.835 -2.61462 -3.20134 -11.4125 -4902 6 6.2936 16 18.7476 -12.5252 7.31014 22.9936 -4903 4 5.79227 16.5246 19.4216 24.8679 -4.64947 -16.2991 -4904 4 5.64136 15.3462 18.514 -6.08951 -9.62478 -9.34051 -4905 6 8.52033 14.5365 24.6875 -9.84601 3.26611 -2.01077 -4906 4 9.36791 14.3624 25.0978 6.86066 0.30113 1.47813 -4907 4 8.18366 13.6846 24.3866 1.77672 -1.96336 3.84573 -4908 6 22.6911 10.1297 32.1351 -27.5214 -52.5729 10.3709 -4909 4 22.3884 10.9899 32.3649 2.47289 32.4289 -2.22619 -4910 4 23.5203 10.1223 31.6812 20.4751 21.0076 -14.9216 -4911 6 11.292 2.12704 14.679 -26.9964 -14.1635 0.457424 -4912 4 10.3004 2.01295 14.5746 25.662 7.6895 -7.09692 -4913 4 11.7079 2.38272 13.8392 -0.157448 -3.91762 -7.39795 -4914 6 44.9096 15.591 36.2717 33.6405 -1.91298 -30.8875 -4915 4 45.0764 15.4828 35.303 -3.33411 7.1012 27.4883 -4916 4 43.99 15.446 36.3379 -31.2371 -2.78707 10.2167 -4917 6 9.72465 19.0179 31.2227 19.6005 -24.8416 -16.8371 -4918 4 10.5897 19.4265 31.3159 1.30764 -1.40065 3.11778 -4919 4 9.11252 19.5759 31.653 -23.8989 17.913 16.8503 -4920 6 51.9714 7.58847 16.6881 21.0297 -20.8952 -55.8985 -4921 4 52.6598 6.90966 16.567 -10.1825 8.15334 22.1112 -4922 4 51.6538 7.5728 15.7392 -8.87714 21.5211 34.751 -4923 6 31.4317 34.7753 36.422 -0.942044 -9.40807 -31.2122 -4924 4 31.7249 34.7672 37.3268 6.30465 10.9632 14.3566 -4925 4 31.2441 35.6593 36.0754 6.17504 10.5044 11.3925 -4926 6 4.22663 15.0937 15.3657 -12.9272 -11.1361 22.285 -4927 4 4.10058 14.8824 16.3208 1.18356 5.05287 -17.269 -4928 4 5.17453 15.1773 15.2713 12.4851 5.61025 -4.39011 -4929 6 47.7531 20.6767 28.0224 11.2198 -3.02063 -12.9376 -4930 4 47.6925 19.771 27.6598 -2.10862 13.919 9.51432 -4931 4 48.3916 21.1163 27.4231 -12.1395 -0.81062 10.3277 -4932 6 15.815 1.15165 24.4078 -58.142 17.9603 -16.0616 -4933 4 15.2825 0.557615 24.9446 12.6892 -15.3828 1.22604 -4934 4 15.0545 1.63036 23.9524 41.7436 -8.72437 9.7488 -4935 6 34.5811 39.7067 40.0776 25.1973 35.6425 -42.1699 -4936 4 34.2041 40.3093 40.7031 -18.6223 -6.05265 24.4589 -4937 4 34.3171 38.8242 40.1905 -21.7766 -38.3424 16.3885 -4938 6 20.1959 32.1778 34.4064 -21.1308 28.8301 22.4919 -4939 4 19.7756 32.8897 35.0113 13.9702 -37.934 -23.8567 -4940 4 21.1121 32.1056 34.6926 -2.59197 2.17732 9.39736 -4941 6 19.2966 38.5284 11.8437 26.0429 16.0259 -0.414132 -4942 4 19.2747 37.5954 11.9891 -3.91225 -17.7096 3.53088 -4943 4 20.0654 38.8356 12.3915 -17.5462 -2.40166 -9.14392 -4944 6 6.53181 13.5016 26.8314 -26.032 48.4544 -13.2533 -4945 4 5.96734 14.0602 26.204 31.1233 -23.713 24.7575 -4946 4 6.50803 12.6321 26.4707 -0.853216 -24.803 -10.5103 -4947 6 23.5899 31.5666 33.3383 5.98922 -6.50638 -9.93577 -4948 4 23.0479 31.6137 34.1308 1.15429 -4.79335 1.92272 -4949 4 23.6428 30.629 33.0606 -7.31668 7.17491 0.194963 -4950 6 41.0566 31.9249 16.2102 56.5158 -30.8904 -22.4873 -4951 4 41.9283 32.0344 16.659 -25.525 5.07155 -0.752829 -4952 4 41.3339 31.2779 15.4895 -19.0587 21.5349 12.1439 -4953 6 31.7523 18.8667 19.3593 3.35741 25.414 0.712525 -4954 4 32.0759 19.7269 19.7383 -8.81617 -22.0304 -12.3923 -4955 4 31.2718 18.4298 20.0739 7.05067 -2.94537 3.38628 -4956 6 10.4941 4.11052 19.3414 6.42456 29.4713 -33.6332 -4957 4 9.72315 4.57262 18.9428 7.32966 -14.5804 7.11 -4958 4 11.2095 4.33965 18.6811 -15.5987 -11.1936 33.5314 -4959 6 1.36933 32.4682 19.2841 21.0988 -14.4161 24.2075 -4960 4 2.01529 31.7231 19.2122 -13.2253 9.85044 -10.2965 -4961 4 1.01532 32.721 18.4367 5.36339 -4.1954 -20.4987 -4962 6 42.8687 16.8583 24.9978 45.6636 -43.4462 -50.5941 -4963 4 42.5079 17.7172 24.9824 -17.3855 32.283 0.331695 -4964 4 43.4322 16.7911 24.1362 -30.0172 8.55702 44.8961 -4965 6 45.317 19.181 4.10785 3.8422 34.8536 -4.15721 -4966 4 46.019 19.8398 3.89275 -2.03222 -14.2005 10.5278 -4967 4 44.6424 19.7199 4.5744 3.59127 -10.0852 -3.22755 -4968 6 29.1417 19.8939 35.7514 6.11075 -32.58 -16.2332 -4969 4 28.6926 20.3067 36.4515 -23.9686 13.1333 31.3988 -4970 4 29.2427 20.5957 35.1143 7.28783 5.32225 -12.4577 -4971 6 31.9564 21.8498 19.6592 2.82401 14.2352 -0.350828 -4972 4 32.7548 21.9543 19.0677 -31.5105 -7.28354 24.2009 -4973 4 31.6217 22.7614 19.848 10.5207 -20.3739 -6.13763 -4974 6 39.1981 8.2717 18.8284 -32.9061 14.1933 0.428726 -4975 4 38.9624 7.35629 18.6463 1.07118 -6.83808 -1.96228 -4976 4 38.3348 8.76709 18.6863 31.0345 -14.9445 1.78619 -4977 6 33.2818 13.2775 41.2684 -13.2208 -33.3764 1.31987 -4978 4 32.393 13.5626 41.0006 -3.83673 2.91025 7.56978 -4979 4 33.1808 12.3338 41.5845 5.22215 22.8712 -2.04361 -4980 6 5.9413 29.5498 35.797 -32.456 -34.3071 -6.72563 -4981 4 6.35963 30.284 36.1739 22.861 33.0715 10.0739 -4982 4 6.49565 29.1835 35.1072 8.32337 2.91553 -5.44074 -4983 6 13.0321 34.2086 31.915 -24.835 -40.2345 36.8573 -4984 4 13.0272 33.4084 31.376 1.88868 -0.760633 -7.07942 -4985 4 12.5489 33.9041 32.737 18.271 18.5714 -18.1292 -4986 6 33.9591 21.7903 18.011 18.8454 -21.734 -8.71067 -4987 4 34.7458 21.1933 18.012 -16.5142 3.18134 2.17277 -4988 4 34.2934 22.6573 17.8484 16.983 20.6817 -10.003 -4989 6 35.9748 41.3385 18.1559 -11.3515 0.0380054 -35.3696 -4990 4 35.8093 41.5204 17.1769 9.12346 -12.4659 34.6458 -4991 4 36.6045 0.098617 18.3947 7.40652 10.177 5.52403 -4992 6 34.8515 37.6574 30.5934 11.7527 -35.7483 27.3047 -4993 4 35.1492 36.8608 30.1169 2.57906 15.2804 -10.7791 -4994 4 34.9371 37.33 31.5271 -8.43612 19.6249 -16.9201 -4995 6 26.002 34.4146 4.67279 -8.48904 3.78898 9.19231 -4996 4 25.4415 34.5852 5.42871 -16.9308 -4.98482 2.97274 -4997 4 26.7915 34.86 4.9592 18.7282 4.65341 -5.76761 -4998 6 19.0552 33.5605 1.32358 6.49267 31.5074 -37.6332 -4999 4 19.8139 33.1288 1.70335 8.38847 -12.1483 9.88993 -5000 4 19.4402 34.1326 0.589952 -11.7405 -21.1797 25.0755 -5001 6 25.2648 8.23393 8.59155 9.31521 -3.65292 19.8467 -5002 4 25.4875 8.13778 9.5404 -3.07709 1.08931 -10.3145 -5003 4 25.4314 9.16241 8.38927 -1.28134 -0.00667841 -6.07783 -5004 6 12.8479 19.6935 13.0483 24.3757 5.37981 -4.8091 -5005 4 11.9603 19.9957 12.9501 -28.6845 1.86907 1.18076 -5006 4 13.3523 20.516 12.8959 -4.89806 -16.374 -0.906345 -5007 6 53.3502 11.4299 5.80806 17.1624 -7.42289 17.7098 -5008 4 53.8461 12.0471 6.36061 9.49207 -4.93163 0.0376 -5009 4 52.6392 11.9481 5.49246 -25.6427 10.4986 -14.7278 -5010 6 9.84876 16.0411 31.2026 18.9205 20.8399 7.27663 -5011 4 9.06508 15.7062 30.7868 -18.8641 -2.54228 -13.3824 -5012 4 9.84527 17.0253 31.1624 -7.05614 -14.0763 0.861631 -5013 6 25.427 20.2931 3.30062 11.4464 23.222 26.9187 -5014 4 25.5454 20.7694 4.15249 -9.33169 -17.4988 -10.5652 -5015 4 25.6323 21.0333 2.7154 -3.32412 -15.1122 -12.6987 -5016 6 20.7611 8.20749 15.6389 12.285 -44.7943 -30.6071 -5017 4 20.4521 8.55687 16.4556 -20.4937 3.03897 24.5457 -5018 4 20.4185 7.27697 15.5079 3.31214 29.403 13.2982 -5019 6 37.6491 8.60321 9.97383 13.4411 2.14626 39.4708 -5020 4 37.9762 7.71523 10.2023 -7.3296 7.95364 -3.74733 -5021 4 37.281 8.55077 9.10696 -2.37522 -5.79058 -16.8845 -5022 6 50.6587 4.51935 24.2622 -13.5896 -19.0591 8.29097 -5023 4 49.9232 3.87067 24.2726 8.09814 12.5004 -4.89174 -5024 4 51.4381 3.99879 24.4754 4.23299 2.4676 7.18675 -5025 6 20.1738 24.8175 34.9087 -20.6162 39.8894 -22.5586 -5026 4 19.8889 25.4664 34.1955 11.6566 -19.5752 19.2833 -5027 4 20.4138 24.0094 34.4666 -0.241841 -16.354 -5.00311 -5028 6 30.5812 22.5243 11.2258 -36.8716 21.596 38.6978 -5029 4 31.1688 21.9929 10.7494 35.9784 -15.9007 -22.5785 -5030 4 31.0799 23.2498 11.6175 0.71333 3.79074 -7.65826 -5031 6 17.3246 40.781 8.03002 -31.7256 21.6985 11.3561 -5032 4 17.3609 40.073 8.69249 8.70624 -3.14378 -12.3263 -5033 4 18.1517 40.9293 7.58873 21.0517 -16.9909 -7.06703 -5034 6 23.9551 41.0422 26.0635 49.9815 4.82526 35.6353 -5035 4 24.3667 40.5978 25.3173 -4.54613 -3.84774 -13.2149 -5036 4 23.0402 41.1884 25.9461 -38.539 -4.36769 -14.447 -5037 6 9.79432 25.5848 27.2203 6.65484 -20.1236 -27.319 -5038 4 10.0774 24.9678 26.4912 -4.54744 21.2611 22.5851 -5039 4 10.2742 25.3181 28.0139 -2.97183 -5.43805 2.20583 -5040 6 35.2559 29.8148 24.7567 4.66903 26.9266 -5.93859 -5041 4 34.3843 29.755 24.359 -8.51564 -12.4096 -2.57191 -5042 4 35.4992 30.7322 24.5163 3.09853 -9.53322 8.65044 -5043 6 2.14554 4.24448 10.5593 -22.2482 14.7122 10.1934 -5044 4 1.71214 4.34677 11.4486 21.0071 -10.277 -13.7719 -5045 4 1.55235 4.73342 9.96914 3.10164 -3.012 2.95666 -5046 6 43.1737 3.93442 23.504 -19.8173 -22.9925 0.828755 -5047 4 43.8868 4.03822 22.8829 13.7397 8.75634 -8.56433 -5048 4 42.5624 3.30318 23.0634 7.12322 11.7882 3.68849 -5049 6 18.8936 22.6308 2.43475 37.4693 -11.6119 5.39147 -5050 4 19.8359 22.2985 2.41568 -31.8063 3.38645 -2.45846 -5051 4 18.7431 22.7947 3.37318 -4.67781 1.83629 -1.28906 -5052 6 20.5039 18.9394 41.5502 -45.0653 -1.00263 50.2155 -5053 4 20.0478 18.6838 0.506021 30.3651 -1.16827 -32.2456 -5054 4 19.9073 19.6506 41.2865 12.7012 -1.26976 -15.3796 -5055 6 26.407 7.54687 29.1121 1.4357 2.47637 1.41449 -5056 4 25.6724 7.10479 28.6297 19.9382 8.96422 9.98625 -5057 4 27.0918 7.77745 28.4582 -11.2115 -7.41118 6.83701 -5058 6 25.6474 35.5684 33.7551 28.3954 -27.4775 -24.9773 -5059 4 26.3573 36.1942 33.5448 -9.56627 7.56335 10.8035 -5060 4 25.9974 34.7724 33.2466 -29.6941 19.0168 23.1671 -5061 6 24.829 0.49304 8.41898 49.9168 25.8876 59 -5062 4 25.5758 0.370102 9.1289 -47.1903 5.46774 -40.7742 -5063 4 24.7798 41.5674 8.0141 -4.73142 -31.3088 -22.2887 -5064 6 17.0191 17.3177 3.44507 -46.3903 19.7373 51.2207 -5065 4 16.2469 17.9517 3.64762 33.8447 -23.651 -21.8207 -5066 4 17.1185 16.9245 4.35427 5.98982 5.76213 -27.3591 -5067 6 40.1787 32.0965 19.3495 -2.04197 44.459 1.39821 -5068 4 39.7315 31.3261 19.6693 2.08081 -28.8107 0.337304 -5069 4 40.9568 31.869 18.8472 6.84111 -19.9226 -1.15348 -5070 6 23.382 26.6945 6.30636 26.5913 52.1271 15.5788 -5071 4 24.0556 27.4456 6.44648 -17.1373 -33.2326 -1.34025 -5072 4 22.7142 27.1153 5.75328 -6.08389 -4.52619 -7.61988 -5073 6 28.6524 28.5085 1.41248 40.8971 -13.4399 -11.1281 -5074 4 28.8916 29.4207 1.30452 -22.1266 20.7664 -4.28256 -5075 4 29.5558 28.1704 1.18501 -32.1523 -8.03877 13.3744 -5076 6 12.0456 6.33448 14.0345 -15.8903 -34.4 -29.7535 -5077 4 11.2902 6.05291 13.4483 16.0844 18.9407 21.6686 -5078 4 12.7823 5.99392 13.4906 5.33453 16.7776 14.1371 -5079 6 20.1258 33.7078 32.0959 -18.1893 1.56867 -4.93457 -5080 4 20.1945 33.0222 32.7471 -6.29187 -8.74149 18.477 -5081 4 21.0272 33.8529 31.8657 20.6776 7.89431 -10.0095 -5082 6 12.0665 33.3691 34.5458 -17.2285 -56.0193 -22.1145 -5083 4 11.5086 33.8793 35.1106 -7.76206 16.4549 16.9315 -5084 4 11.5605 32.4987 34.4127 27.4292 33.0374 0.608769 -5085 6 6.00658 22.2666 25.0532 -19.3255 -5.39958 94.237 -5086 4 5.834 22.4197 24.1868 -9.01045 11.6196 -89.8037 -5087 4 5.17345 22.6031 25.4913 31.6285 -9.76338 -3.83253 -5088 6 28.8848 9.49767 11.035 16.7623 9.63116 22.4077 -5089 4 29.0495 10.2086 11.6768 10.1151 -22.3542 -11.392 -5090 4 28.083 9.83925 10.6889 -25.6685 -5.48517 -25.0151 -5091 6 25.9808 31.1499 24.8669 6.22835 -24.9986 7.12483 -5092 4 26.2942 31.9621 24.5011 4.31737 18.7644 -10.9339 -5093 4 26.6597 30.4768 24.6157 -18.0541 8.02771 8.13926 -5094 6 17.4051 22.6403 26.9653 -7.75883 36.9734 2.0054 -5095 4 17.2144 23.5004 27.4753 3.96627 -41.4428 -18.3441 -5096 4 17.5261 21.9375 27.6083 1.93016 -8.19761 6.25563 -5097 6 30.9714 17.6252 1.64088 21.0154 14.9482 37.3685 -5098 4 30.2059 17.6112 1.0839 -20.4324 5.80492 -14.3468 -5099 4 30.9516 18.4373 2.23396 3.22156 -25.7853 -22.8165 -5100 6 35.2764 9.72503 11.2414 -18.3895 -2.76749 -51.624 -5101 4 34.6551 9.56245 10.4589 20.7383 2.80865 37.1903 -5102 4 36.1302 9.43155 10.8742 2.68762 -2.05229 10.7544 -5103 6 12.0172 10.802 4.27563 -38.9121 -6.07101 -4.90761 -5104 4 11.4313 10.6374 5.04504 13.8247 1.49432 -7.40831 -5105 4 11.4074 10.5604 3.53263 22.811 5.33779 9.30002 -5106 6 52.9577 23.1313 7.67787 -9.3269 3.09364 -7.79077 -5107 4 53.8153 23.0871 7.22609 1.51949 2.98805 -1.25247 -5108 4 52.6879 24.0607 7.78743 10.5919 -6.87524 0.0783357 -5109 6 27.3762 5.80009 23.1013 37.771 37.8703 25.2466 -5110 4 28.2178 5.56094 23.5856 -32.2451 -1.57897 -13.9899 -5111 4 27.4704 6.79781 23.0764 -15.1432 -38.3322 -6.34326 -5112 6 22.7771 37.7063 15.5287 -6.89324 -10.2053 44.7861 -5113 4 22.8198 37.7465 14.5962 3.81902 5.91484 -35.4551 -5114 4 23.2903 36.9427 15.8415 -1.83068 2.7653 -4.67104 -5115 6 30.583 30.1381 39.7472 11.9278 5.78959 4.89923 -5116 4 30.1399 29.6129 39.0656 -4.27402 4.25284 -2.63349 -5117 4 30.6547 31.067 39.4612 -8.3831 -13.7724 -7.9353 -5118 6 26.5154 14.8633 29.9609 11.0831 -12.5589 -33.9006 -5119 4 25.6935 15.2477 30.2118 -18.1143 15.4408 19.147 -5120 4 27.1376 14.9035 30.6723 6.99544 5.71887 23.1856 -5121 6 9.52617 19.5446 37.4141 -27.8096 33.0225 -3.94279 -5122 4 8.56344 19.6819 37.5998 22.5694 -19.9005 4.13551 -5123 4 9.71087 20.3892 36.9619 8.68778 -16.8671 10.038 -5124 6 0.93064 14.8656 2.69338 -45.7679 -11.5139 71.6593 -5125 4 1.44105 15.217 2.01526 37.3122 25.2366 -40.5783 -5126 4 0.982855 15.4275 3.5214 11.2099 -15.0526 -29.9277 -5127 6 46.4291 27.1302 41.5927 44.8021 -5.11347 -18.4756 -5128 4 47.4269 27.1857 41.3316 -52.8753 -1.56841 10.8767 -5129 4 46.0453 26.5632 40.9031 3.09365 7.20255 7.14326 -5130 6 47.6703 23.0461 21.3817 14.1329 62.5249 18.4178 -5131 4 46.9615 23.2467 20.7836 -14.1781 -2.67912 -10.5965 -5132 4 47.8255 22.1376 21.4096 0.736735 -54.6337 -3.62162 -5133 6 39.861 22.2186 3.09273 14.3751 -13.6386 -17.8056 -5134 4 38.9812 22.2192 3.47284 -7.54245 -0.786418 6.90323 -5135 4 40.0217 21.2868 2.78929 -10.5756 29.8648 14.1337 -5136 6 14.9857 14.9315 33.4628 8.45923 30.4043 17.83 -5137 4 15.3946 15.8263 33.6275 -11.7248 -28.7506 -9.93609 -5138 4 14.5839 14.7058 34.318 1.67348 -1.86342 -8.89677 -5139 6 27.3225 11.4951 31.9326 -53.5602 -46.3542 13.457 -5140 4 26.8632 12.0627 32.5566 10.8872 8.4751 3.08438 -5141 4 28.1269 11.8297 31.6518 53.6341 36.944 -15.9306 -5142 6 36.7606 7.97817 7.63938 -5.6216 -14.483 -15.6739 -5143 4 35.961 7.43887 7.80711 8.78578 3.79539 -7.6162 -5144 4 37.414 7.37034 7.2323 -6.45073 3.96969 3.37374 -5145 6 49.4351 9.64395 18.2091 29.626 55.2849 10.866 -5146 4 50.1121 10.1978 17.7651 -9.80365 -29.4086 -13.348 -5147 4 49.2806 10.2909 18.9191 -22.4891 -21.6225 2.73598 -5148 6 27.0558 33.8708 10.7695 -35.2964 21.4972 9.63291 -5149 4 27.0077 33.3399 10.0051 13.5655 -23.8621 -34.587 -5150 4 26.1863 34.3133 10.6733 10.9844 1.63438 18.9088 -5151 6 11.1931 37.467 6.82672 4.88099 -16.6436 19.1561 -5152 4 10.8369 38.341 6.72067 -6.30082 13.8936 -5.38019 -5153 4 12.1372 37.6177 6.93955 5.33816 -5.06614 -4.03667 -5154 6 19.2682 19.4041 21.904 -23.2853 8.1035 46.9014 -5155 4 18.5523 19.4276 21.2977 -21.2798 -5.04156 -20.5384 -5156 4 20.0545 19.4439 21.4012 35.6905 -5.22778 -21.4405 -5157 6 54.5004 2.91828 22.5705 32.5661 -1.01917 48.733 -5158 4 54.2618 3.02388 21.6728 -2.16971 10.501 -40.9175 -5159 4 0.435524 3.25313 22.7695 -30.9494 -6.38648 -13.13 -5160 6 45.0599 10.868 24.2364 14.5135 -18.2796 4.13426 -5161 4 44.3635 11.4663 23.9664 0.226806 13.7258 12.1538 -5162 4 45.5813 11.1999 25.0017 -10.9868 0.331296 -15.4884 -5163 6 14.3917 34.4176 24.7766 -9.76404 -18.453 -6.38428 -5164 4 14.7761 35.2693 24.9957 4.99605 2.44674 1.2141 -5165 4 14.8449 34.0832 23.9904 0.575187 7.45256 -7.27956 -5166 6 50.5869 17.5623 4.30497 19.1488 -58.6727 24.3661 -5167 4 51.3501 17.8958 4.78847 0.670503 12.5806 -1.04554 -5168 4 50.1422 18.2474 3.88142 -19.7161 48.0777 -23.3625 -5169 6 14.9242 33.337 34.1076 -18.6172 33.5363 80.554 -5170 4 15.0808 32.9083 33.3321 11.226 -38.5345 -73.3592 -5171 4 14.0723 33.0217 34.4665 7.96171 10.4343 -9.42002 -5172 6 20.8631 33.5747 38.9135 21.2953 11.2024 -25.7312 -5173 4 20.865 34.0752 39.7143 -3.94121 7.45437 24.6588 -5174 4 20.36 32.7884 39.0656 -12.436 -21.6406 1.81461 -5175 6 7.7707 4.74963 26.7362 26.5342 -10.6541 19.1955 -5176 4 7.23261 4.91898 27.5026 -6.83786 10.9421 8.37469 -5177 4 7.15089 4.73593 26.0203 -3.95236 1.60233 -15.9617 -5178 6 9.2875 21.4887 22.2941 45.0197 -19.5209 20.7118 -5179 4 8.6739 21.9912 21.7696 -4.21454 15.1903 -23.2464 -5180 4 10.2572 21.6206 22.0058 -46.5259 5.6334 -2.177 -5181 6 20.5439 38.2154 8.85856 -11.8412 3.64647 49.7312 -5182 4 20.3505 38.5634 9.79035 9.75602 -4.66312 -40.2998 -5183 4 20.2844 37.2891 8.95048 10.2824 2.6457 -7.05014 -5184 6 30.1005 39.0839 30.7484 -12.1958 38.1552 23.9792 -5185 4 30.3724 39.9578 31.2326 -12.541 -45.9124 -25.2432 -5186 4 29.1103 39.003 30.8437 30.6219 6.07536 -1.13857 -5187 6 16.0462 22.036 24.5064 2.37861 -9.55962 -5.99251 -5188 4 16.6334 21.9741 23.7207 6.17482 7.89117 19.2285 -5189 4 16.5569 22.3155 25.2979 1.4399 -2.17025 -8.02685 -5190 6 5.74172 29.2061 14.4603 -14.7312 11.1013 -1.58992 -5191 4 6.41865 28.6839 14.8489 24.8954 -16.4528 0.429681 -5192 4 5.37542 29.618 15.2515 -13.4536 5.99623 -6.25212 -5193 6 28.0689 3.08071 25.2267 -3.20814 35.3244 14.901 -5194 4 28.6407 3.76435 24.8336 -2.36389 -14.401 -4.10269 -5195 4 27.6795 3.6106 25.9691 7.41152 -23.0621 -10.2478 -5196 6 45.9381 29.3111 31.4283 -35.5447 25.9568 9.82539 -5197 4 45.677 28.707 30.7493 2.31008 -18.1922 -21.3643 -5198 4 45.1265 29.9079 31.4744 34.4717 -15.8255 11.1052 -5199 6 11.2229 22.8376 36.7897 -1.27591 2.9175 -5.69903 -5200 4 10.6623 23.4314 36.25 10.4728 -5.78036 -0.0474996 -5201 4 12.0147 22.5841 36.2713 -9.37786 4.28983 5.66853 -5202 6 18.9444 40.1485 39.92 -15.471 -8.01044 2.33142 -5203 4 19.1439 39.1941 39.9507 -1.34087 5.25319 4.4419 -5204 4 18.8847 40.4877 40.8271 3.43659 -8.21326 1.76593 -5205 6 23.5503 26.0803 21.2869 1.98517 -8.46863 16.2364 -5206 4 22.847 26.649 20.9475 -0.393515 -5.32061 4.06564 -5207 4 23.2913 25.6403 22.1336 -2.29953 13.2014 -21.5927 -5208 6 16.8518 5.38834 15.8565 -25.8193 5.07215 -6.0744 -5209 4 16.3979 5.3834 15.0179 8.08064 -16.6857 -11.3384 -5210 4 16.3642 6.13153 16.2159 17.5374 8.90145 23.838 -5211 6 12.0293 26.6115 15.0052 48.8575 28.3431 -20.5386 -5212 4 11.753 25.9113 15.557 -22.1508 -25.2102 16.954 -5213 4 11.3677 26.9943 14.4309 -20.7091 -9.23994 -0.184726 -5214 6 14.3404 41.4231 2.37222 21.8802 31.2536 -15.2067 -5215 4 13.6639 41.0433 2.88545 -29.1815 -25.4177 23.2655 -5216 4 14.3137 0.446574 2.65591 6.04323 -12.5169 -2.89291 -5217 6 50.3994 35.8721 9.32148 7.74023 -5.00078 -0.0244409 -5218 4 50.7985 35.7097 8.44539 1.7624 12.9821 5.72804 -5219 4 50.9327 36.5364 9.8137 -9.76519 -8.88391 -14.7497 -5220 6 11.3732 22.6657 26.8674 13.5542 4.36995 9.37334 -5221 4 12.2226 22.4007 26.49 -3.86507 -2.48494 3.34128 -5222 4 10.7274 22.4174 26.2153 -14.8849 -5.84603 -9.40936 -5223 6 8.44501 34.5567 21.2657 -4.1178 -59.9386 7.63204 -5224 4 8.06567 35.1301 21.9247 -8.42944 2.78434 16.8569 -5225 4 8.10966 33.58 21.4462 13.1168 58.8803 -11.2866 -5226 6 9.4289 8.66253 24.4817 -31.3326 14.2813 -20.5935 -5227 4 8.45611 8.64572 24.2655 24.8039 10.7682 6.42659 -5228 4 9.52915 9.21836 25.2644 -0.461641 7.68001 5.20174 -5229 6 32.603 22.3274 34.5057 1.1064 -2.38466 -37.2003 -5230 4 32.4525 23.1707 34.0368 4.85154 -2.46017 7.68642 -5231 4 32.8396 22.5701 35.3818 7.58742 14.9461 32.9529 -5232 6 26.736 26.1837 7.12165 10.4716 16.8024 -17.1295 -5233 4 25.9537 25.8031 7.51207 -7.84415 -15.2109 12.7352 -5234 4 26.4604 27.1054 6.93432 8.77765 -19.2484 4.4957 -5235 6 34.0014 11.9295 3.96807 -3.56186 4.82634 5.33773 -5236 4 33.6494 11.5631 4.78494 7.3544 2.33703 4.85457 -5237 4 33.8594 12.8842 4.06904 0.478869 -2.08104 -5.13073 -5238 6 21.473 20.924 37.1992 5.8677 19.4674 12.3893 -5239 4 22.3242 21.3752 37.157 2.6693 1.87465 3.04951 -5240 4 21.708 20.0203 37.0255 -6.20277 -25.1527 -1.47337 -5241 6 18.4792 41.0219 0.672743 -35.2491 -25.3697 -26.4792 -5242 4 17.5363 41.1592 0.451811 6.2729 -6.09178 6.10687 -5243 4 18.7532 41.8934 0.847545 18.5165 37.9853 8.81983 -5244 6 41.3458 41.7141 25.1818 17.8335 14.8146 -1.57438 -5245 4 40.8444 40.9381 25.3951 -6.7286 -20.9895 5.67055 -5246 4 41.5773 41.6158 24.2546 -2.61686 2.51709 -2.2804 -5247 6 27.6337 28.128 3.93443 68.2433 49.922 -72.4808 -5248 4 27.747 28.0641 2.90056 -5.60951 6.59214 55.905 -5249 4 26.974 27.5707 4.19301 -60.7891 -51.6503 16.466 -5250 6 18.2766 10.5218 31.4985 31.6557 -13.945 -4.11948 -5251 4 17.4661 10.038 31.5755 -21.8827 2.32902 1.26527 -5252 4 18.1351 11.463 31.4681 -8.30794 8.79106 3.21692 -5253 6 11.3047 37.9513 14.7719 14.2766 22.5792 8.51892 -5254 4 10.8196 37.2524 14.3384 -3.55752 -10.2024 4.33151 -5255 4 11.8722 37.607 15.4977 -19.1201 -2.12261 -16.4117 -5256 6 0.810718 18.1323 27.5767 30.9572 19.3393 -0.702274 -5257 4 0.190255 17.4711 27.3024 -13.6082 -17.9307 4.12615 -5258 4 1.6652 17.6816 27.7433 -15.3641 2.36995 -0.952151 -5259 6 36.7957 10.7342 20.2882 16.9593 17.0847 7.18326 -5260 4 36.2525 10.0089 20.0111 -13.8544 -11.0907 -5.31633 -5261 4 36.5766 10.8708 21.2175 -0.466777 -2.92115 4.06643 -5262 6 47.4269 25.5204 8.035 -8.77625 7.04012 -26.0141 -5263 4 47.2351 25.672 7.07342 16.0738 -5.10236 26.6147 -5264 4 46.6031 25.1946 8.38488 -7.38433 -0.0309169 8.21918 -5265 6 13.9121 35.1279 15.9963 57.6206 21.904 15.8158 -5266 4 13.18 34.6338 16.2776 -41.6081 -30.4219 4.97616 -5267 4 13.8612 35.4714 15.1124 -11.7278 3.29634 -19.5683 -5268 6 29.56 35.3617 16.1847 -46.2751 8.28104 -14.7299 -5269 4 30.2098 34.9035 16.6971 16.3841 -9.08849 15.1595 -5270 4 28.6495 34.9755 16.3324 34.0842 8.73794 -6.93478 -5271 6 29.4892 25.8842 32.4194 -24.256 -10.4352 -29.1805 -5272 4 28.8256 25.7516 33.0892 -1.91161 2.59937 23.0953 -5273 4 29.0388 25.4531 31.6468 24.6149 5.96309 7.68736 -5274 6 24.1242 2.12171 25.4449 33.2745 25.8541 -21.7468 -5275 4 24.4973 2.84525 24.8288 -6.14236 -31.0627 26.9036 -5276 4 24.7925 1.39916 25.5361 -16.9688 12.032 -10.1501 -5277 6 4.54733 34.4389 19.1463 -35.302 -7.10976 -3.39284 -5278 4 4.35486 34.5879 18.2161 16.9971 0.874352 -7.12679 -5279 4 3.63202 34.4395 19.5005 25.743 -3.14875 11.9651 -5280 6 10.1206 17.2361 14.3164 8.36708 -29.6599 -28.3251 -5281 4 10.306 17.5039 15.1955 -0.106022 16.7729 24.4966 -5282 4 9.5035 17.8022 13.8616 -7.59249 10.3925 2.01091 -5283 6 21.4437 41.7724 34.6698 -12.6382 -8.67476 11.1219 -5284 4 21.3209 41.1297 35.367 19.1323 -10.7035 11.8578 -5285 4 20.52 0.052046 34.4982 -0.738196 4.11389 -17.598 -5286 6 36.1618 24.1149 12.6039 -38.5184 -29.276 -18.6614 -5287 4 35.5274 23.7914 13.2897 25.4622 4.78071 -2.2183 -5288 4 35.751 23.7447 11.7708 17.6549 15.9976 15.8112 -5289 6 49.5813 18.6026 19.9424 19.3655 4.31785 -3.79274 -5290 4 50.05 19.3681 19.5461 -11.4841 -9.87428 2.01803 -5291 4 50.2881 17.9408 20.0283 -8.44417 3.53865 1.64593 -5292 6 1.24663 7.05846 14.4912 39.2605 -25.8072 -27.0237 -5293 4 1.83321 6.85564 13.6734 -27.5618 7.792 37.3713 -5294 4 1.40902 6.33035 15.1313 0.69425 14.6008 -10.3474 -5295 6 12.7431 22.7725 31.2519 -28.0711 -22.2846 -24.537 -5296 4 12.731 22.0484 30.5842 -1.03989 14.4355 17.1556 -5297 4 13.6361 23.0601 31.2889 29.0982 7.61123 0.941905 -5298 6 8.17623 18.6217 27.8167 28.4831 -7.95646 -20.137 -5299 4 8.40342 17.6669 27.8028 -7.19499 14.8132 8.92302 -5300 4 8.90402 18.9943 27.2753 -13.5351 -1.9306 8.34595 -5301 6 52.1398 28.0368 15.3061 -5.99984 -2.63203 -6.56281 -5302 4 52.212 27.4921 14.5152 3.50742 -7.1981 5.43712 -5303 4 52.1344 28.9249 14.9274 -1.52971 -5.17654 6.68842 -5304 6 52.6974 21.8977 10.081 -19.9085 6.90605 5.3514 -5305 4 53.3388 22.3376 10.626 19.2735 6.64212 5.60719 -5306 4 52.8023 22.3165 9.21858 0.448532 -1.39229 -3.54893 -5307 6 22.3312 5.79987 2.67028 14.2956 -6.96789 22.7666 -5308 4 22.4342 5.66665 3.62826 -7.95027 2.50856 -4.24886 -5309 4 22.7763 5.02131 2.34757 -2.68692 -18.1597 -17.0707 -5310 6 15.4178 16.2178 21.8878 29.1139 16.3559 -34.9346 -5311 4 14.4763 16.1482 22.0206 -17.0561 3.51129 1.66656 -5312 4 15.5967 16.6295 20.979 -16.1676 -12.6325 35.129 -5313 6 28.6996 41.2944 33.8986 -0.299799 0.972013 4.01662 -5314 4 28.6528 40.5712 34.5346 5.69191 -6.81028 -1.89437 -5315 4 27.7925 41.4039 33.5788 7.00998 2.71453 4.16387 -5316 6 9.0271 31.2603 18.2166 -24.0632 3.5617 9.69965 -5317 4 9.00312 32.2249 18.3215 -0.833429 -0.795431 1.49639 -5318 4 8.39564 30.8695 18.8792 23.5138 4.17381 -14.686 -5319 6 20.5401 20.4009 18.1765 -9.82111 13.5354 -7.0052 -5320 4 21.0961 20.6619 18.9088 6.00228 -1.57494 14.3732 -5321 4 19.8969 21.1451 18.1138 9.42471 -20.4088 -2.28899 -5322 6 53.9632 14.7108 37.8185 38.9936 -13.777 37.4998 -5323 4 53.5065 15.4999 38.0588 -19.2143 21.2037 -5.62994 -5324 4 53.6553 14.2856 37.0504 -18.643 -5.89619 -29.3657 -5325 6 28.9005 15.3805 18.8553 43.4355 2.75939 -10.7082 -5326 4 29.8744 15.2601 18.5577 -43.1698 -4.30042 15.6378 -5327 4 28.8821 15.3937 19.8257 1.95554 -2.72042 -0.550014 -5328 6 2.00757 25.8231 18.9102 1.56834 13.1457 16.4238 -5329 4 2.16994 26.6099 18.3718 5.10623 3.14141 1.15535 -5330 4 1.76535 25.1325 18.3092 -5.75322 -15.1157 -18.9078 -5331 6 53.2586 40.7003 24.294 -3.95682 23.2035 5.10337 -5332 4 53.3627 39.7881 24.0333 10.577 -13.1769 -1.30533 -5333 4 54.0929 41.151 24.0537 -8.8009 -7.19084 1.91562 -5334 6 47.531 32.0044 22.8424 -9.22212 4.73076 14.8806 -5335 4 47.3777 32.6735 23.5302 -5.63931 6.65432 -9.88941 -5336 4 48.2144 31.4763 23.2497 9.41484 -5.26157 -3.09765 -5337 6 24.6289 26.1478 33.0175 -22.0968 -9.02062 -12.6011 -5338 4 24.4656 25.5474 33.7557 -1.10221 8.12594 5.97613 -5339 4 25.4283 26.6445 33.1202 14.9272 4.196 4.65224 -5340 6 21.3417 17.0876 39.4763 -6.70912 6.89414 0.748051 -5341 4 22.0272 16.5901 39.8927 14.9242 -9.38388 2.18929 -5342 4 20.9728 17.5957 40.2063 -4.43123 6.71259 -1.60026 -5343 6 11.0417 40.4515 17.0271 -4.84825 -47.9733 -31.3307 -5344 4 11.617 41.1325 17.3235 21.4854 16.9952 0.793724 -5345 4 11.529 39.8797 16.3454 -22.439 27.66 32.3414 -5346 6 20.3522 21.2696 39.8718 -25.2322 13.8952 23.2629 -5347 4 20.7065 20.9823 39.0558 13.3567 -12.8249 -34.1322 -5348 4 21.0787 21.2544 40.4999 1.2931 1.07094 1.93889 -5349 6 2.11891 29.6947 22.5962 -10.9271 -4.15175 -1.48688 -5350 4 1.41229 29.0196 22.6861 11.0269 1.69063 -12.8134 -5351 4 2.97173 29.2673 22.4434 -6.16143 -1.40449 -3.11444 -5352 6 36.756 30.301 35.4561 22.3149 -30.6991 6.56967 -5353 4 36.1659 29.9908 36.1617 3.98829 10.9575 -2.82389 -5354 4 37.5905 29.761 35.5884 -25.1141 24.4323 0.251817 -5355 6 12.9563 4.31922 37.9158 -41.9162 -7.49401 17.923 -5356 4 12.213 3.67486 38.0016 27.2031 5.98064 4.05536 -5357 4 12.5797 5.11915 38.3509 20.8388 -3.72048 -10.4757 -5358 6 38.3368 5.25882 18.4553 -27.9454 13.7946 -11.1943 -5359 4 37.494 5.12162 18.8921 -4.17763 4.09508 -3.9191 -5360 4 38.9486 5.03087 19.1262 32.9808 -9.34357 19.7422 -5361 6 10.4991 9.23341 21.7308 -20.3579 1.12747 21.1104 -5362 4 10.1476 9.35811 22.629 -2.53412 -6.58654 -7.03761 -5363 4 11.4429 9.27697 21.8681 13.0367 -0.194449 -11.5952 -5364 6 0.510441 41.039 17.3204 -22.411 45.8537 -1.19125 -5365 4 1.10275 40.3438 17.515 21.9532 -27.5034 12.6219 -5366 4 0.955429 41.8901 17.5577 -0.403404 -22.4144 -8.21181 -5367 6 4.11028 5.06714 6.43108 -32.0559 -10.673 -25.0156 -5368 4 4.76196 4.43778 6.68194 21.2279 -22.0503 -6.17775 -5369 4 4.3376 5.79555 6.94869 8.69612 42.0455 26.6358 -5370 6 11.4527 25.4042 0.173069 -8.87291 20.1751 -4.43043 -5371 4 11.3037 26.302 0.51034 -2.48968 -2.12098 1.34892 -5372 4 12.3912 25.256 0.330533 -7.09022 -12.0676 2.67745 -5373 6 7.43008 21.5598 8.10589 6.84767 -16.7382 -30.018 -5374 4 7.67559 21.2373 7.18738 -12.1375 12.6211 33.8068 -5375 4 8.24892 21.8626 8.52003 -6.07298 -1.72571 -6.46698 -5376 6 47.5896 16.3642 25.2431 -28.5582 13.6976 -25.6498 -5377 4 46.6075 16.1608 25.1822 37.2389 5.55574 -4.66364 -5378 4 47.8562 16.8152 24.3682 -3.16196 -14.4146 40.515 -5379 6 30.9292 19.5125 39.8483 -41.4217 8.94898 -20.4144 -5380 4 31.859 19.4188 40.0164 22.9308 8.40553 1.58818 -5381 4 30.7224 20.3633 39.3589 16.5857 -27.3682 15.8932 -5382 6 20.3871 24.0387 39.4036 8.00795 23.2793 -8.75093 -5383 4 19.459 24.1701 39.2693 -20.2994 13.2523 2.58474 -5384 4 20.4244 23.1071 39.4874 5.50164 -36.2952 5.14995 -5385 6 45.8871 21.2471 41.1655 20.5283 25.7578 0.477301 -5386 4 46.6385 21.2626 41.7552 1.12624 -15.6366 20.1575 -5387 4 46.1812 21.9667 40.5962 -14.858 0.0662744 -14.6758 -5388 6 32.5732 28.1983 30.4559 17.8923 -19.7368 14.2663 -5389 4 32.9661 27.3096 30.6426 -14.7491 22.8943 -8.37245 -5390 4 33.2232 28.8091 30.8453 -8.57676 -1.81844 -4.53088 -5391 6 18.0207 1.32021 27.0363 -34.7874 1.53884 20.0911 -5392 4 17.0721 1.60205 27.1202 27.3864 -5.2263 -11.315 -5393 4 18.3294 1.50373 27.9381 11.4124 1.84961 -11.8648 -5394 6 39.378 24.9761 21.8758 -21.83 -3.15726 3.51608 -5395 4 39.2925 25.9351 21.9975 13.0773 -1.30024 -1.60914 -5396 4 38.5262 24.6687 22.2439 10.6836 3.42961 -4.87158 -5397 6 33.5904 21.3057 22.0908 0.876878 23.3779 1.34154 -5398 4 32.7037 21.4589 21.7601 -6.64994 -10.6299 -4.35651 -5399 4 34.0298 22.1428 21.8479 4.87062 -13.8873 3.79153 -5400 6 40.1162 15.0006 15.7553 -16.7667 -72.1851 -56.1125 -5401 4 39.3246 14.5665 15.2764 38.6699 22.9899 20.5541 -5402 4 39.7685 15.7046 16.224 -23.0828 51.553 35.6364 -5403 6 32.7063 17.9241 6.36312 -6.65812 28.0098 -27.693 -5404 4 32.6631 17.3286 7.08836 -4.96405 -26.2659 23.6138 -5405 4 32.2202 17.5402 5.61621 0.349997 -9.22032 2.43078 -5406 6 50.4717 15.9308 31.1336 -57.0185 -34.1342 43.3708 -5407 4 51.2677 16.1483 30.7347 55.5832 16.4654 -29.6643 -5408 4 50.5499 15.0059 31.4683 -2.42192 20.1529 -11.8828 -5409 6 23.8292 29.3322 31.6407 10.3974 -8.56959 5.42825 -5410 4 23.7096 29.6981 30.7618 4.3803 -0.813234 -2.10966 -5411 4 24.6813 28.8378 31.6594 -15.3785 13.3689 -4.34977 -5412 6 25.0524 41.6477 38.2806 4.00174 7.46449 -31.3583 -5413 4 25.6511 41.367 37.5454 -10.3054 -0.491554 23.0497 -5414 4 24.5276 0.474703 37.8884 8.98972 -6.87862 14.9811 -5415 6 14.3299 25.4693 7.99598 -51.8246 -23.5651 26.6357 -5416 4 15.0301 25.7523 7.4663 39.147 18.3395 -31.3738 -5417 4 13.6749 25.0466 7.38907 19.2382 9.49844 7.52052 -5418 6 17.2117 20.7467 5.34291 -12.6959 30.9635 29.5807 -5419 4 17.5658 20.2645 4.6512 13.3362 -42.6322 -45.6451 -5420 4 17.6752 21.5763 5.21476 -4.76461 12.1014 12.8322 -5421 6 18.8578 10.961 23.7113 11.9098 -52.6755 14.4862 -5422 4 18.5821 10.3312 23.0139 -2.7304 18.9854 0.947207 -5423 4 18.7069 11.8432 23.4586 -8.32501 34.3086 -18.4054 -5424 6 7.80658 41.3805 11.0401 -9.04392 11.0606 6.15122 -5425 4 8.00429 40.5098 11.4059 2.67644 4.01258 -4.23655 -5426 4 8.51691 0.066 11.3394 -1.81513 -7.16892 -1.05394 -5427 6 48.6966 23.1832 34.0648 -27.3561 -6.76338 -18.0805 -5428 4 48.0792 22.9132 33.32 19.6766 11.2437 24.8207 -5429 4 49.5669 23.23 33.6693 11.2336 0.854645 -6.12438 -5430 6 53.7246 23.5588 15.3422 -2.2993 4.88061 -38.5045 -5431 4 54.0115 23.9686 14.4981 1.04624 9.96871 20.6807 -5432 4 53.2132 22.8493 14.9574 -7.54922 -9.79714 16.7607 -5433 6 22.2409 5.63035 9.83732 -4.74687 0.990813 -28.4051 -5434 4 21.8007 4.9012 9.36518 5.41421 2.33681 17.3637 -5435 4 22.5704 6.16354 9.07597 -3.08255 -9.23766 25.1176 -5436 6 33.6677 8.38805 9.07277 4.65141 2.45263 2.68713 -5437 4 32.9476 8.96499 9.32099 -11.143 10.7473 10.4723 -5438 4 33.4213 8.08448 8.2012 2.38155 -0.0587928 -10.5973 -5439 6 47.3188 37.7205 20.3441 15.215 11.7573 -25.0114 -5440 4 47.5704 37.5879 19.4187 8.2864 3.06637 8.88956 -5441 4 46.6261 37.0853 20.3703 -21.7602 -22.9037 19.9419 -5442 6 30.8605 16.7391 10.6102 -28.0995 -48.2853 23.2284 -5443 4 30.4428 17.1675 11.4048 8.00556 -5.70758 -17.8294 -5444 4 30.5213 15.7576 10.5828 6.17084 54.1408 -3.58748 -5445 6 48.1227 27.723 10.1192 -17.271 38.6552 19.8549 -5446 4 48.941 27.5885 10.6019 15.4404 -6.10886 -7.64033 -5447 4 47.9667 27.1056 9.42146 1.69339 -23.2576 -13.9441 -5448 6 27.3465 38.6397 25.5972 -19.3603 -43.7567 25.3821 -5449 4 28.2552 38.3171 25.6348 3.73027 6.4174 -6.06634 -5450 4 27.3175 39.4354 25.1025 9.7616 28.5552 -11.1584 -5451 6 33.3485 5.72785 21.4502 -30.5322 15.1217 -10.2054 -5452 4 32.7106 6.21453 20.8566 24.3968 -18.0484 15.2917 -5453 4 34.2142 6.02589 21.2258 21.3261 10.3595 -12.9949 -5454 6 25.3097 5.14436 4.52462 -12.6707 -6.42781 10.7366 -5455 4 25.8166 5.03621 5.34324 9.24373 -0.000563512 -7.52253 -5456 4 24.4109 4.89546 4.80865 9.45245 1.955 -8.20101 -5457 6 40.4804 35.6472 19.1595 -4.18239 -17.2552 -25.1441 -5458 4 40.6473 35.1871 19.989 -0.677015 6.66802 10.9293 -5459 4 40.3876 36.5867 19.2889 2.08163 9.85771 9.62751 -5460 6 49.6466 30.6357 19.0258 14.8172 21.4531 -43.5404 -5461 4 50.0494 29.991 18.4245 -6.82309 -11.6442 2.45506 -5462 4 49.4912 30.1943 19.8303 -8.11919 -24.8089 39.0949 -5463 6 42.1414 28.3198 17.0336 30.9261 -8.96587 16.5499 -5464 4 41.9014 28.1134 16.1233 0.612516 -1.09878 -6.61247 -5465 4 42.9986 27.8356 17.2327 -32.0588 11.6021 -17.9905 -5466 6 47.7009 24.529 36.3602 12.6164 -10.6945 -29.4467 -5467 4 46.9511 23.9476 36.4057 -12.614 -6.01445 14.1932 -5468 4 48.02 24.3175 35.4647 6.89481 1.31964 6.68358 -5469 6 19.3487 26.9773 19.8132 -7.91098 29.1703 -3.69101 -5470 4 19.5772 26.0513 19.7652 -2.42994 -17.6971 2.90599 -5471 4 18.7132 27.1892 20.5145 5.94626 -13.5516 -3.80193 -5472 6 47.0594 26.8038 37.5124 29.171 -27.35 55.5912 -5473 4 46.5442 27.3901 37.0243 -28.7601 35.2651 -40.4696 -5474 4 47.4575 26.1126 36.9775 -8.83233 1.8809 -11.4479 -5475 6 9.306 24.6801 40.2841 31.4937 0.109789 0.329283 -5476 4 9.78189 23.9102 39.8717 -14.0424 16.7407 17.3327 -5477 4 10.0272 25.2082 40.7306 -19.6308 -16.1327 -14.1874 -5478 6 14.4855 17.9139 14.2735 23.8217 -2.3356 -5.96097 -5479 4 13.7756 18.1909 13.6871 -0.445295 3.10639 3.20472 -5480 4 15.2926 17.8532 13.6969 -24.9099 1.36359 15.4275 -5481 6 37.1333 38.6708 18.7289 9.24178 15.507 -32.6939 -5482 4 36.7257 39.5382 18.5851 -4.02817 -0.227247 6.07181 -5483 4 37.6697 38.5833 17.9067 -2.91955 -11.3843 16.172 -5484 6 11.4153 5.92336 21.4477 15.4675 -15.5323 24.3843 -5485 4 12.0347 5.46444 22.0611 -14.8481 11.1792 -11.8992 -5486 4 10.9828 5.22117 20.955 -5.02219 -4.37746 -7.57367 -5487 6 4.24672 30.7112 16.2271 25.0754 -37.7862 10.5022 -5488 4 4.05441 31.4608 15.7204 -4.71706 34.9582 -31.1175 -5489 4 3.72964 30.8334 16.9988 -11.892 -2.06994 24.4228 -5490 6 17.6689 16.0105 27.0706 -11.532 -19.4613 -16.5334 -5491 4 17.475 15.0322 27.0999 0.550485 29.0366 -12.0979 -5492 4 17.2014 16.3875 26.2691 10.8221 -16.0252 20.0561 -5493 6 36.4979 8.6445 40.4253 22.1182 5.90925 -1.87084 -5494 4 36.6649 9.56092 40.6574 -3.64727 2.10984 0.486612 -5495 4 35.6642 8.36755 40.7885 -12.5441 -1.64485 2.44437 -5496 6 13.6104 12.9476 3.01337 -0.796658 -1.76047 52.4558 -5497 4 13.281 12.534 3.85665 2.0295 3.09436 -35.1239 -5498 4 14.3672 13.4568 3.35498 1.79634 -1.71495 -16.7359 -5499 6 38.5663 20.1511 21.6276 16.2684 -2.59448 10.3838 -5500 4 39.225 20.3435 20.957 3.66548 0.723189 -1.42015 -5501 4 37.7399 20.1987 21.178 -26.4348 -4.9091 -11.1397 -5502 6 51.0002 10.2707 30.836 -20.0759 -41.5967 21.7358 -5503 4 51.4945 11.0341 30.626 15.2265 30.1997 -10.6067 -5504 4 50.365 10.1656 30.1217 2.42758 1.75416 -9.76943 -5505 6 16.2768 2.44039 41.3342 24.5898 23.894 -47.9169 -5506 4 15.7659 1.68969 41.4668 -26.4768 -52.1654 31.458 -5507 4 16.2309 2.46185 40.3616 9.12406 8.41144 7.6857 -5508 6 16.5823 4.96192 41.8916 -4.82165 52.2801 -70.6027 -5509 4 16.7504 4.9538 0.881833 10.2709 -3.72182 62.3109 -5510 4 16.3825 4.09214 41.6138 -6.48385 -26.7637 5.90228 -5511 6 38.2132 37.6512 20.9834 35.6931 -0.0015793 9.16781 -5512 4 38.1132 38.2158 20.1985 1.71026 -5.63736 5.42755 -5513 4 39.175 37.679 21.2752 -35.8773 5.52261 -11.9395 -5514 6 27.3063 1.90932 15.7743 -36.1781 7.04456 22.02 -5515 4 27.5288 1.21363 15.1745 3.62804 -9.29946 -19.0329 -5516 4 26.3092 1.89423 15.8276 27.8398 0.929522 -3.41863 -5517 6 29.0129 12.4346 37.8081 29.6396 -2.3639 23.3235 -5518 4 29.5703 13.228 37.8521 -9.25731 3.38449 -11.2245 -5519 4 29.432 11.8866 38.5178 -20.735 6.92768 -10.3763 -5520 6 46.0725 20.1624 18.9069 6.39102 14.9163 -14.6323 -5521 4 45.1723 20.516 18.8892 1.91785 -0.379773 0.405435 -5522 4 46.587 20.7656 18.3221 -3.54001 -13.7442 9.74416 -5523 6 2.03634 38.6845 18.4933 3.82981 -3.85695 21.6638 -5524 4 2.81563 38.6864 19.0472 23.4807 10.2435 -12.678 -5525 4 1.45125 38.3557 19.1766 -27.1945 -1.99387 -8.3623 -5526 6 44.0469 24.9707 25.966 7.80173 10.6441 20.9452 -5527 4 44.2747 24.0363 26.0952 1.37736 2.33249 -4.33209 -5528 4 43.5784 25.0701 25.1359 -3.49858 -7.6437 -6.59112 -5529 6 5.98346 26.6137 4.53144 23.0758 4.04073 24.4329 -5530 4 6.55391 27.1627 5.13089 -15.1794 -12.3526 -15.6845 -5531 4 6.29729 25.6938 4.67268 -13.7287 18.2257 -9.78447 -5532 6 0.087877 23.2081 10.934 24.9145 3.46447 1.10559 -5533 4 0.685292 23.7315 10.3726 -8.08066 -2.01306 3.92681 -5534 4 0.721975 22.7627 11.5282 -19.4067 -0.934622 -1.78644 -5535 6 39.1228 20.6282 12.8796 23.5823 -4.01912 3.74068 -5536 4 40.0483 20.9095 13.1274 -25.2182 -11.8294 -4.75086 -5537 4 38.9288 21.0058 12.0111 3.51405 8.21934 1.48951 -5538 6 39.9585 39.9542 18.8548 8.25477 7.63818 -34.14 -5539 4 39.6086 40.5348 18.1328 12.8912 -23.3113 16.3656 -5540 4 39.4227 40.1355 19.596 -22.4924 5.25798 25.9214 -5541 6 49.2764 23.011 30.5163 -3.77364 -44.6036 15.8547 -5542 4 49.4289 23.7872 30.0082 18.6126 30.182 -14.9565 -5543 4 49.9621 22.8706 31.1946 3.66181 18.5012 -4.70792 -5544 6 10.3518 2.34263 9.13761 -0.60969 70.0656 33.4022 -5545 4 10.2194 1.51752 8.76453 -19.3013 -48.5596 -30.1763 -5546 4 9.57958 2.95755 9.02478 16.8019 -18.7251 -1.57756 -5547 6 9.61453 40.9339 19.7468 19.8516 -54.9951 -16.0575 -5548 4 9.63195 40.6865 18.7859 0.317082 16.3896 20.6195 -5549 4 10.0376 40.0904 20.1458 -24.9194 43.0231 -10.2629 -5550 6 29.2525 5.10109 17.4961 7.67774 22.6856 2.90325 -5551 4 29.0408 4.77134 16.6193 -6.82779 -3.03985 -6.7526 -5552 4 29.5295 6.02934 17.3335 -2.58265 -16.5067 4.76001 -5553 6 27.0985 15.4102 3.23556 -13.4453 -81.1273 -7.3603 -5554 4 27.3652 16.2806 3.27349 18.8182 67.1491 11.283 -5555 4 27.7776 14.8512 3.68225 -14.3437 21.6428 -0.863725 -5556 6 32.8444 39.3852 25.121 -7.01244 -52.8845 44.4676 -5557 4 32.5131 40.2222 24.9368 -10.8075 51.8916 -16.2411 -5558 4 32.4445 39.2315 26.0289 16.1191 -0.874654 -30.671 -5559 6 34.9513 7.88207 31.2328 20.4504 58.5219 2.42802 -5560 4 34.2036 8.45679 31.498 3.65199 -12.2289 -1.35309 -5561 4 34.6861 6.99719 31.2488 -20.0023 -44.0519 1.25651 -5562 6 6.12467 36.7605 26.1486 23.5936 30.152 20.8626 -5563 4 6.61267 37.4751 26.6609 -18.7565 -29.2185 -15.3031 -5564 4 6.64666 36.6639 25.3566 0.873799 -8.15108 -9.63468 -5565 6 6.01736 25.8242 24.1032 -23.71 11.4997 43.6127 -5566 4 6.27054 25.4519 24.9889 5.69321 0.899098 -34.3464 -5567 4 5.25039 26.3671 24.4036 11.002 -12.3451 -22.9516 -5568 6 45.616 24.3868 2.54557 6.93899 11.9467 -1.18645 -5569 4 46.5025 24.2318 2.18535 0.269069 -11.0786 2.08994 -5570 4 45.6283 24.2142 3.48441 5.93067 -6.10702 12.3332 -5571 6 15.5106 11.7053 32.6869 22.7313 15.5035 25.4621 -5572 4 15.7644 12.551 33.1413 -9.31293 -24.2108 -12.4541 -5573 4 14.956 11.9719 31.9681 -12.2379 8.7831 -14.7046 -5574 6 46.4141 17.7037 37.4783 -24.8433 -42.9552 -46.1347 -5575 4 46.5841 17.8832 38.3706 6.4658 9.03355 44.3658 -5576 4 46.0203 16.778 37.4148 6.08678 36.5836 2.96135 -5577 6 39.713 20.917 18.528 13.2313 30.5311 40.8197 -5578 4 40.433 20.5782 18.0298 13.2747 -18.0123 -24.5712 -5579 4 40.2054 21.5165 19.1543 -30.2447 -12.7963 -15.6911 -5580 6 23.8051 28.0334 36.6648 -18.7533 17.1228 48.8478 -5581 4 23.301 27.37 37.1661 8.15196 -5.41595 -20.5023 -5582 4 23.699 28.7533 37.3439 14.557 -4.10395 -29.4534 -5583 6 23.235 0.659798 30.8906 16.7198 -34.3804 0.301059 -5584 4 23.3562 41.8891 31.5781 -2.93034 5.1259 -1.85649 -5585 4 23.9222 0.433479 30.2226 -16.4688 10.6885 3.12481 -5586 6 37.1438 6.89027 28.2945 -2.75708 2.50278 32.0481 -5587 4 36.7625 6.23385 28.9496 14.7229 22.3106 -21.8828 -5588 4 37.4874 7.65333 28.8474 -13.0775 -21.14 -18.6628 -5589 6 3.23769 6.61111 12.3846 0.723209 -17.9385 -9.61551 -5590 4 2.93962 6.7917 11.4726 6.04883 11.0603 10.3219 -5591 4 3.59705 5.70622 12.3141 -7.8292 10.6871 9.81534 -5592 6 12.6213 19.1513 31.1215 -11.7593 -39.2703 -9.13055 -5593 4 12.5689 18.1911 31.4279 4.41954 36.1073 -0.401864 -5594 4 12.3049 19.0952 30.1995 4.23471 8.33584 13.9505 -5595 6 15.1895 38.3194 41.5508 -8.26313 0.106571 5.96729 -5596 4 15.4027 38.685 40.6867 1.58925 3.7734 1.08261 -5597 4 15.977 37.8419 41.8199 8.82113 -1.67422 -0.112624 -5598 6 49.6344 33.3417 19.6414 -43.1776 -42.2962 -0.847743 -5599 4 48.6794 33.3996 19.9697 35.2792 3.84356 -17.7841 -5600 4 49.66 32.3974 19.2778 11.8172 40.1309 17.1575 -5601 6 6.36572 2.78375 29.9004 1.05055 15.8156 -22.8281 -5602 4 6.36575 3.75042 29.7262 1.90425 -15.9719 7.25575 -5603 4 5.96593 2.68858 30.7619 0.24665 -4.47807 16.8647 -5604 6 13.1696 31.768 30.2754 -6.44409 10.1839 -14.6274 -5605 4 12.7931 32.0108 29.386 8.00869 -8.49993 19.6421 -5606 4 12.9985 30.8211 30.4317 -1.17466 7.15103 -3.10169 -5607 6 32.315 32.2433 24.9103 28.3535 -13.0924 -48.465 -5608 4 32.6582 31.5201 24.3183 -18.8106 4.4732 28.5514 -5609 4 32.6906 33.004 24.4312 -3.21058 9.63112 20.1287 -5610 6 42.0003 14.5628 37.421 -39.889 12.6212 -8.37855 -5611 4 41.095 14.1415 37.3281 37.9102 -1.96214 -0.320241 -5612 4 42.7025 13.9066 37.3517 -4.02931 -15.6388 2.60245 -5613 6 11.8892 7.23447 27.6701 3.45884 -4.12236 4.5236 -5614 4 11.8415 6.40302 28.2109 -4.80024 17.2153 -14.4092 -5615 4 11.297 7.16355 26.8983 -0.411327 -9.99206 8.34553 -5616 6 14.2054 37.5349 6.88535 -5.50304 -50.1586 -23.8091 -5617 4 14.4448 38.4425 6.82842 11.1201 34.2121 -5.16838 -5618 4 14.5404 37.0855 6.04727 -8.45912 19.5264 31.302 -5619 6 14.2389 30.7101 36.0658 7.9951 22.3707 -6.00421 -5620 4 14.3369 30.7582 35.119 5.20948 5.89711 -15.5268 -5621 4 14.162 29.7856 36.1796 -2.50712 -40.828 17.27 -5622 6 16.4199 33.6465 5.49971 39.8982 -12.4718 -37.0106 -5623 4 16.8881 34.472 5.38053 -10.1033 13.7438 12.8324 -5624 4 16.9383 33.116 4.82328 -31.4907 -2.1142 22.2677 -5625 6 23.0347 17.1509 7.84843 -2.98061 53.305 10.417 -5626 4 22.2528 17.4913 7.37616 0.35347 -20.1342 1.7373 -5627 4 23.3535 18.0122 8.2624 2.91922 -40.8936 -9.01863 -5628 6 51.739 20.8998 27.7117 45.1346 -9.91933 19.8422 -5629 4 51.4539 20.5938 28.5983 0.576611 5.87017 -14.8878 -5630 4 52.7517 20.9693 27.7878 -43.3794 -0.870523 -11.1135 -5631 6 2.19386 27.6013 28.8077 21.9852 1.77593 -20.6905 -5632 4 2.90112 28.2633 28.7865 -8.94698 7.25322 21.5481 -5633 4 2.57794 26.9939 28.1568 -21.2327 -10.3447 8.82052 -5634 6 17.2209 14.3445 7.70498 -9.6153 -40.0176 25.3709 -5635 4 16.7414 14.2178 8.5755 19.2823 5.01031 -25.0594 -5636 4 17.7242 13.4894 7.54274 -12.7499 32.9606 1.11211 -5637 6 12.4553 8.94194 14.7093 23.4905 -30.5738 22.1451 -5638 4 12.3295 7.96561 14.6517 -10.6336 18.1935 -14.5798 -5639 4 13.0902 8.95069 15.466 -13.8235 22.031 -14.7981 -5640 6 42.4163 38.0607 9.75492 -41.3892 12.3524 0.930734 -5641 4 43.2155 37.8504 10.1985 23.5031 -2.65638 19.8551 -5642 4 41.8128 38.5249 10.3845 19.1619 -5.0707 -9.72644 -5643 6 51.8291 30.3524 28.2725 -23.4976 -15.3182 24.0858 -5644 4 51.4769 31.1806 28.0071 -16.9091 20.9854 -6.54852 -5645 4 52.5669 30.2698 27.7075 37.0459 -10.0857 -13.876 -5646 6 0.173291 18.5306 4.58887 -6.78508 26.3933 6.63194 -5647 4 0.366643 18.0957 3.77581 2.61413 -8.62723 -27.1515 -5648 4 0.528197 17.9664 5.25604 0.668563 -20.2899 17.5992 -5649 6 34.1542 0.618182 3.01035 -64.6642 7.59467 -29.5426 -5650 4 33.2756 0.91071 2.55681 38.9521 -14.8268 28.0312 -5651 4 34.8139 1.0189 2.46529 20.392 14.9436 -5.19898 -5652 6 49.1703 17.2445 23.163 11.3421 -28.7232 -23.3687 -5653 4 50.0948 17.5226 22.997 -11.4987 -1.8789 7.34388 -5654 4 49.1149 16.3391 22.7575 3.35316 27.0342 8.27414 -5655 6 23.1508 6.50484 23.6205 15.3745 23.1125 -33.0506 -5656 4 23.1854 7.14565 22.8174 -14.1016 -25.0292 28.8988 -5657 4 22.2566 6.27815 23.8868 -11.3625 11.3028 -1.57795 -5658 6 11.0777 24.0866 29.2726 3.42799 -14.5151 -26.2344 -5659 4 11.3051 23.4915 28.5104 -10.7193 12.1306 15.2701 -5660 4 11.7189 23.8646 29.9475 6.00027 1.59973 10.1126 -5661 6 36.5499 4.08922 21.6769 -9.80126 5.87302 -21.3361 -5662 4 36.3976 4.50823 22.521 3.21878 -0.144303 13.033 -5663 4 36.3054 4.80832 21.0596 6.63301 -13.9203 1.83546 -5664 6 31.3023 25.6432 24.5943 15.0376 6.85795 28.0728 -5665 4 31.291 26.2789 25.3519 -12.6017 -14.5788 -25.478 -5666 4 32.0941 25.1064 24.7955 -9.59576 -0.449362 -7.93794 -5667 6 42.6065 23.029 14.7662 -46.2562 -12.0705 -53.1337 -5668 4 42.8654 23.3474 13.8766 8.33796 6.77145 13.2285 -5669 4 43.1929 23.285 15.4255 44.8404 21.8098 38.991 -5670 6 14.3111 11.6689 8.88632 -19.0153 -23.9468 -21.906 -5671 4 13.3495 11.3817 8.87766 31.9146 14.5471 0.24728 -5672 4 14.742 11.0378 8.25313 -7.14597 12.5116 20.7778 -5673 6 21.4992 2.13393 3.40246 8.36864 -2.88126 -9.61958 -5674 4 22.4231 2.22963 3.69686 -12.58 -3.45743 -2.69439 -5675 4 21.4721 1.34946 2.81138 2.62282 6.56171 18.4043 -5676 6 22.4667 27.6841 39.0793 -16.1771 -11.2193 -33.3168 -5677 4 22.9487 28.2311 39.6723 13.8114 13.1168 21.0188 -5678 4 22.2331 26.8853 39.529 -0.753476 -8.75647 11.2468 -5679 6 37.2752 33.5075 30.0534 -5.09816 -29.8969 21.2662 -5680 4 36.5321 32.9121 30.2938 11.1992 13.6878 -5.37502 -5681 4 38.0391 33.1092 30.5204 -9.59535 7.6329 -11.7718 -5682 6 41.8356 20.8755 40.0084 -30.1785 -26.2846 -15.3963 -5683 4 40.891 20.6843 40.2338 21.7839 7.55089 -6.55796 -5684 4 42.213 21.2736 40.7728 12.4306 8.07023 23.0746 -5685 6 10.0585 31.1051 22.2503 24.8691 -18.1602 32.094 -5686 4 10.0242 30.9652 23.2199 -0.323131 -4.21186 -18.2592 -5687 4 9.26251 31.5457 22.0526 -32.5358 14.9165 -12.561 -5688 6 24.2061 35.3797 6.65176 29.8647 -7.74501 -52.0461 -5689 4 23.2981 35.13 6.46942 -12.5131 3.59528 11.7489 -5690 4 24.436 35.6291 7.5325 -13.5066 3.92126 26.0938 -5691 6 54.2205 13.3707 18.7548 -14.8606 0.23157 2.49876 -5692 4 53.5905 13.2954 18.0026 12.0308 5.79113 16.3195 -5693 4 53.7072 13.5032 19.578 4.97112 -2.65932 -16.1217 -5694 6 12.4895 25.0856 17.4479 -5.54126 21.12 19.6166 -5695 4 12.0527 25.8035 17.9613 1.96295 -15.4272 -10.9144 -5696 4 12.9797 24.5872 18.1192 -7.22993 -2.38631 -13.5888 -5697 6 22.3914 33.9622 18.8899 -17.7941 -3.8788 -25.186 -5698 4 22.7777 34.3519 18.0802 1.20341 3.55679 12.7761 -5699 4 21.5828 33.5138 18.532 26.0363 5.82114 13.25 -5700 6 24.4442 12.917 5.83205 -1.35281 -9.13891 6.68087 -5701 4 24.5112 13.8355 6.04562 11.139 23.8521 5.95609 -5702 4 23.7978 12.9208 5.12829 -4.38592 -8.75699 -5.70796 -5703 6 13.4045 11.2384 28.602 -9.94106 -32.5269 -0.345522 -5704 4 13.7125 10.4202 28.1467 1.06973 22.7078 1.68844 -5705 4 12.6883 10.856 29.1417 2.50959 12.0169 -5.49025 -5706 6 20.9681 34.6931 21.1354 15.1203 14.42 -6.16036 -5707 4 21.5009 35.1121 21.8248 -8.94458 -7.77672 4.1779 -5708 4 21.5063 34.8208 20.3262 -11.2236 -10.4562 8.09593 -5709 6 37.1336 34.5207 26.1541 -9.5297 -36.7224 -3.07541 -5710 4 37.2109 34.2142 25.2288 3.21082 15.1766 11.7274 -5711 4 37.5352 35.3664 26.2639 8.9577 18.3348 -6.65469 -5712 6 49.3622 27.1182 23.4746 39.7066 -11.0301 13.9767 -5713 4 48.4746 27.3502 23.3119 -43.65 9.96054 -8.06751 -5714 4 49.6716 26.7458 22.6451 -3.30563 -9.15784 -7.68388 -5715 6 2.6564 41.733 27.6477 -1.65257 -10.3676 0.180548 -5716 4 2.5349 41.5868 26.6785 2.71482 14.5166 10.808 -5717 4 3.44733 0.360291 27.8573 -13.8821 -2.9337 -13.5775 -5718 6 28.2538 5.65865 0.855763 -50.2522 -11.1502 7.99105 -5719 4 29.1126 5.92525 0.635025 43.8938 8.11388 -11.2713 -5720 4 28.2366 4.68907 0.832778 5.05155 4.08711 2.73992 -5721 6 46.3376 19.9476 30.6448 -5.32264 7.02196 22.3264 -5722 4 46.9473 19.8004 29.9179 3.84913 9.17517 -5.42643 -5723 4 46.6125 20.7672 31.1318 -5.12963 -19.3092 -16.4827 -5724 6 3.64577 25.7701 21.5553 -12.766 27.4814 -12.397 -5725 4 3.72382 24.8593 21.8343 3.84868 -9.88757 -5.52558 -5726 4 3.13913 25.8588 20.7173 13.2009 -15.3518 9.10855 -5727 6 2.75122 19.0968 29.6319 -2.61118 -0.882922 8.96218 -5728 4 3.5891 18.6871 29.8565 3.14038 -9.81989 10.1431 -5729 4 2.90737 19.4327 28.7602 3.1882 14.1904 -12.7773 -5730 6 11.8953 35.7778 24.2646 -23.8517 23.4638 0.926703 -5731 4 12.2722 34.9198 24.2954 23.5909 -23.1933 0.784725 -5732 4 12.5229 36.3761 23.8548 12.2449 3.68762 -3.83655 -5733 6 52.3409 30.3775 14.3038 25.9342 24.3497 3.27132 -5734 4 52.8186 31.1218 14.7277 1.28259 -10.3571 -1.87569 -5735 4 51.5459 30.7912 14.0165 -25.7225 7.74731 -5.34623 -5736 6 0.083662 24.3704 32.1159 7.87696 -1.86575 0.949534 -5737 4 0.925887 24.7254 31.8116 -7.58302 1.2158 -10.0766 -5738 4 0.064605 24.6797 33.0182 -11.6947 5.89195 12.8097 -5739 6 31.4941 23.7355 38.8139 13.6067 4.55671 22.3988 -5740 4 31.5922 23.3599 39.6955 6.6148 17.5079 8.63317 -5741 4 30.9989 23.0266 38.4646 -21.4094 -18.5611 -29.2329 -5742 6 52.1193 21.6104 3.49599 14.6151 -31.0847 -13.388 -5743 4 52.9641 21.5934 2.99085 -20.8635 4.42776 5.19501 -5744 4 52.1025 22.4297 3.95509 1.85636 27.8943 8.87727 -5745 6 31.7523 33.9412 11.6017 9.59211 -24.6365 -8.99112 -5746 4 31.343 34.2459 12.4067 -7.95657 10.1636 10.9534 -5747 4 32.0734 33.0348 11.7994 -4.73133 20.193 -2.42319 -5748 6 7.03486 17.6719 16.6685 29.0057 -41.5114 -49.367 -5749 4 6.91092 17.0215 17.3537 -7.78637 4.64801 28.8113 -5750 4 7.29826 17.0034 15.9319 -18.9591 50.1453 28.7374 -5751 6 51.8542 41.8728 22.1898 10.246 17.2442 -13.5357 -5752 4 52.3028 41.4443 22.9054 19.3182 -6.61148 18.5368 -5753 4 51.1068 41.3135 22.0792 -27.0964 -11.4612 -2.03348 -5754 6 50.8737 9.93347 25.9376 -32.929 -21.31 0.307119 -5755 4 50.6075 10.0984 25.0351 -2.54905 2.45869 -5.94774 -5756 4 51.7134 10.3221 26.0527 29.2363 20.0336 5.9403 -5757 6 9.00178 39.8723 13.8451 -19.3622 -18.1235 -30.983 -5758 4 9.55792 39.3182 14.3856 9.60602 -5.37935 8.26515 -5759 4 8.70771 39.29 13.0873 14.4347 20.6992 23.854 -5760 6 40.6986 25.5526 0.136544 19.9096 -17.3535 33.0343 -5761 4 40.3666 25.3638 1.04053 0.834228 7.76146 -13.9079 -5762 4 41.6521 25.7245 0.296606 -16.7956 -8.725 -14.7957 -5763 6 46.6823 7.83196 22.8561 10.1499 25.8504 33.9562 -5764 4 46.2788 7.49308 23.6743 -2.78909 -8.0392 -13.1915 -5765 4 47.099 8.65892 23.1926 -4.50937 -8.82075 -14.1875 -5766 6 20.9875 12.9068 9.95805 -11.691 32.2034 24.7109 -5767 4 21.4351 12.3054 10.5167 21.854 -26.8991 22.1196 -5768 4 21.3309 12.7465 9.11062 12.4417 -9.66517 -44.3579 -5769 6 24.8453 0.514421 28.6038 13.082 22.7197 -2.81433 -5770 4 24.715 0.071792 27.7548 -6.16819 -1.63374 -2.91335 -5771 4 25.0442 1.45997 28.4028 -6.72102 -19.281 3.08734 -5772 6 9.94041 22.6855 8.28517 -18.2906 18.759 -35.6321 -5773 4 10.3442 21.9586 7.83344 17.071 -18.1108 1.7387 -5774 4 9.60436 23.1702 7.48056 7.13277 7.40532 33.7222 -5775 6 33.2759 9.25429 23.8257 8.37106 -55.2845 13.9355 -5776 4 33.3237 10.1123 23.4806 -1.26345 47.1757 -20.4798 -5777 4 34.1087 8.81977 23.5578 -8.47821 6.16632 5.2483 -5778 6 47.7984 20.3614 34.2959 -41.6158 20.0741 -32.6301 -5779 4 47.162 20.9095 33.7523 35.4977 -6.5354 18.8426 -5780 4 47.2264 19.5923 34.4121 13.8381 -6.37745 11.1074 -5781 6 7.49292 13.4971 41.09 9.79805 -11.8131 -23.6679 -5782 4 7.49901 13.1324 40.1715 -6.0705 12.8605 17.5951 -5783 4 8.32745 13.1637 41.4633 -5.36906 3.36653 2.36319 -5784 6 9.96112 23.6102 1.61114 1.89646 0.256416 -8.05524 -5785 4 10.3422 24.1467 0.893187 3.70522 0.0162214 12.766 -5786 4 9.63217 22.8308 1.16111 -2.5861 -8.4474 -3.4617 -5787 6 27.3279 14.1675 11.3384 -16.3978 3.93745 18.7515 -5788 4 27.0565 14.7974 10.6584 -0.154384 0.736593 1.51299 -5789 4 26.9739 14.5213 12.1957 15.9081 -3.44829 -24.7787 -5790 6 25.8416 31.7729 17.8867 -18.6075 -57.137 -13.4601 -5791 4 26.5498 31.1652 17.5816 -7.88637 19.42 8.67928 -5792 4 26.1364 32.6121 18.1157 31.0786 47.9057 11.8145 -5793 6 28.5054 34.3394 0.220618 54.67 33.5077 11.5224 -5794 4 29.0324 33.8757 0.885908 -4.94848 -3.20805 0.921423 -5795 4 27.711 33.8992 0.092994 -46.8158 -31.9819 -6.78258 -5796 6 39.4821 27.6754 22.7241 37.6977 26.8974 -34.7457 -5797 4 38.562 27.8477 22.7631 -35.1425 8.51836 6.28403 -5798 4 39.8483 28.4606 22.2037 -4.4779 -30.5719 17.4824 -5799 6 19.3989 35.5068 37.6449 44.7238 7.00696 26.241 -5800 4 18.7939 34.9286 37.217 -17.2642 -20.3375 -13.2178 -5801 4 20.0787 34.9056 38.0699 -27.4009 15.1777 -18.4057 -5802 6 40.2622 30.2205 10.7395 23.7464 -4.20556 -44.2191 -5803 4 39.872 30.2327 11.5724 -12.5687 -7.32393 56.9787 -5804 4 39.6265 30.6987 10.2193 -5.46151 14.1383 -16.826 -5805 6 44.8252 28.4803 36.0885 -55.5401 -40.4399 48.4955 -5806 4 44.0914 27.9458 36.6324 49.8455 26.3412 -39.6007 -5807 4 44.7386 29.3482 36.4954 11.2485 4.05282 -13.3799 -5808 6 17.9305 13.9374 34.278 5.37655 43.1893 -39.9004 -5809 4 17.3503 14.7126 34.0365 12.4853 -29.216 13.3111 -5810 4 17.5732 13.4499 34.9957 -23.6035 -11.4222 25.4792 -5811 6 22.772 11.7897 25.9182 -5.92321 66.9234 -24.4623 -5812 4 22.4079 10.9608 26.1065 -2.80798 -46.2844 14.8143 -5813 4 23.7282 11.8442 25.9391 13.2658 -20.917 3.34216 -5814 6 27.9678 31.9745 40.3581 9.67064 -3.036 11.5355 -5815 4 28.3415 32.7469 39.952 3.83939 12.9153 -6.44865 -5816 4 27.8423 31.3481 39.6454 -9.64166 -7.41544 0.62615 -5817 6 29.7189 5.14175 29.7003 46.1252 -36.6163 -19.9261 -5818 4 29.2969 5.47215 30.4671 -15.8461 16.6952 32.1509 -5819 4 30.5834 4.69597 30.0017 -39.473 23.5261 -13.8417 -5820 6 3.10812 21.482 2.76797 0.178067 -30.2305 -7.76436 -5821 4 2.88389 22.394 2.68207 -8.68283 21.8462 0.431797 -5822 4 2.52465 20.9987 2.15107 4.11904 7.00085 10.9335 -5823 6 13.6455 30.6616 39.7413 -31.0251 6.24286 -53.6991 -5824 4 14.4958 30.9276 39.9901 40.59 7.52955 18.7737 -5825 4 13.6028 30.9637 38.7781 -13.7388 -14.6365 40.9566 -5826 6 39.1879 23.0833 28.2631 23.8153 34.0131 -40.8644 -5827 4 39.3603 23.1915 27.276 -9.32936 -4.03115 31.7012 -5828 4 38.6771 22.3028 28.3825 -19.3689 -24.2853 3.44718 -5829 6 16.9942 23.7475 0.782551 23.2332 -11.0525 -6.02825 -5830 4 16.1835 23.4907 1.22514 -0.204047 -3.07314 3.44284 -5831 4 17.6924 23.1245 1.11262 -18.9135 18.2649 -2.71213 -5832 6 0.34625 33.6655 13.0265 -29.0282 32.855 38.2597 -5833 4 54.9333 33.1158 13.7076 7.16186 -20.0974 -8.4449 -5834 4 0.196186 34.5312 13.5136 21.864 -23.0202 -35.8666 -5835 6 49.1134 40.6592 16.9502 -22.6074 7.13526 -12.7963 -5836 4 49.0929 41.0585 16.0481 9.95068 -10.3513 11.1088 -5837 4 48.1763 40.6949 17.2078 7.5264 3.31219 -3.37923 -5838 6 52.1371 39.9932 15.179 23.5783 8.13152 6.60826 -5839 4 51.9212 40.0798 16.1068 2.92809 -1.65288 7.91558 -5840 4 51.3496 39.6649 14.7978 -27.1925 -6.99882 -20.2103 -5841 6 29.0492 37.0934 37.8397 27.862 0.580994 -15.5106 -5842 4 29.7824 36.6456 38.29 -13.83 -0.942856 -3.03347 -5843 4 28.3401 37.1923 38.4583 -14.8343 8.34268 17.6028 -5844 6 4.87483 1.47389 27.5722 8.99005 1.78018 0.412076 -5845 4 5.18955 1.04652 26.7639 -2.94161 4.65408 6.15856 -5846 4 5.65876 1.67721 28.1054 -5.69693 -0.488114 1.02013 -5847 6 43.5905 24.3648 30.2005 -22.2044 -15.6763 19.9702 -5848 4 44.3573 23.9419 29.8442 19.8319 -9.6252 -11.3654 -5849 4 42.9995 23.6287 30.4468 4.54232 11.3491 -5.57307 -5850 6 33.7546 3.53169 22.9281 6.20171 -10.3572 -20.5792 -5851 4 34.1788 2.72522 22.5548 -7.61164 22.2296 6.95503 -5852 4 33.66 4.19918 22.2026 -0.715781 -19.232 19.3758 -5853 6 19.8847 13.4579 25.4063 -13.0952 -9.58357 -31.6265 -5854 4 20.5464 14.0819 25.6574 14.0517 10.8301 14.4774 -5855 4 19.8633 12.7253 26.0209 8.35596 -5.88238 10.9252 -5856 6 47.3765 23.175 39.6238 -8.62258 12.6683 8.16714 -5857 4 47.7656 22.5263 39.0394 4.03481 -11.1372 -12.2265 -5858 4 47.7314 24.026 39.3382 2.38196 -1.35255 2.76448 -5859 6 20.1792 18.6695 32.3892 10.8118 -11.8558 9.82813 -5860 4 19.7451 19.3837 31.9609 -18.6549 15.8768 -14.4176 -5861 4 21.1063 18.8885 32.2904 5.57481 -8.22146 4.6255 -5862 6 0.469489 5.80056 25.6694 -18.1951 25.8664 -34.3154 -5863 4 0.192512 6.63022 25.2132 12.4788 -26.9708 -4.90825 -5864 4 0.599388 6.15564 26.5295 8.98284 3.20038 34.2611 -5865 6 6.87796 19.5502 31.9212 -30.9469 28.3562 -15.4034 -5866 4 6.36899 19.9719 32.666 7.94508 -11.3044 -26.1662 -5867 4 6.51823 19.9652 31.058 21.1032 -17.2362 32.6466 -5868 6 6.72006 20.2763 38.5282 -5.5716 11.964 -18.9783 -5869 4 5.89143 20.7831 38.5761 11.8801 -4.42879 -4.55199 -5870 4 6.91977 20.0675 39.4366 -2.33705 -6.77268 4.9945 -5871 6 22.0131 25.9408 12.2669 -3.54377 -45.9259 -44.7125 -5872 4 21.4169 25.4251 11.6232 6.06411 36.0021 36.1209 -5873 4 22.8575 25.5519 12.0003 5.79029 4.70211 8.19546 -5874 6 39.2956 7.94468 2.64777 3.93347 -3.54621 1.69719 -5875 4 39.6192 7.96721 3.55942 2.89932 9.4301 1.57912 -5876 4 39.5223 7.0665 2.33247 5.57505 -8.53159 -3.65477 -5877 6 29.9733 22.0379 34.4029 6.80249 8.99144 -26.5663 -5878 4 30.9486 21.9114 34.4332 -22.6925 2.47334 -4.63229 -5879 4 29.7282 22.2324 33.4511 1.23467 -5.29722 31.1857 -5880 6 37.585 16.2896 0.378862 9.66072 -32.1652 -13.4334 -5881 4 37.1738 15.3958 0.469359 7.4986 19.6703 2.82788 -5882 4 38.3979 16.0784 41.7811 -5.81955 5.34443 7.8674 -5883 6 11.7199 13.8969 21.9024 0.976022 -4.28814 -52.9061 -5884 4 11.762 13.5091 20.9636 8.25344 3.74313 41.2159 -5885 4 11.7301 13.2111 22.5694 -0.197866 -18.3587 0.721586 -5886 6 33.3547 10.9227 27.6206 7.79028 2.98821 -12.2755 -5887 4 32.7398 11.5851 27.2614 8.9286 -8.03905 3.2582 -5888 4 34.0693 10.7866 26.9485 -19.1033 10.7299 13.3482 -5889 6 30.9479 36.5351 10.0985 1.61282 -58.9885 -21.8283 -5890 4 31.0506 36.3975 9.1055 -4.33965 11.8991 35.1417 -5891 4 31.0192 35.5887 10.4601 -6.41155 39.3119 -7.26857 -5892 6 45.5784 6.55949 25.24 49.1938 -13.828 -6.30557 -5893 4 44.6777 6.5515 25.5065 -25.461 -8.09624 7.65514 -5894 4 45.978 5.64009 25.2752 -26.9592 28.1751 -0.0529727 -5895 6 9.53089 30.0259 12.0468 18.203 -29.4993 -35.3826 -5896 4 9.87965 30.5113 11.2809 1.8895 2.86193 6.03312 -5897 4 9.26134 30.6784 12.652 -18.7794 25.6859 27.1844 -5898 6 53.0787 24.9761 1.37462 5.70131 11.5656 52.3682 -5899 4 52.7701 24.171 1.02302 -14.9871 -27.078 -25.8882 -5900 4 53.2426 25.5756 0.676612 4.18045 17.0305 -26.7636 -5901 6 26.1794 24.7359 0.502901 22.1176 -25.6344 -30.1555 -5902 4 25.7034 24.7594 41.5454 1.42755 5.35042 26.0986 -5903 4 25.8798 25.3805 1.12222 -18.0425 21.9232 11.274 -5904 6 23.006 2.41877 11.549 3.03835 0.786733 -23.201 -5905 4 22.1232 2.19651 11.8728 1.75899 -1.65202 1.96434 -5906 4 22.9163 2.42328 10.5701 -3.31062 2.24291 13.1011 -5907 6 29.9286 12.8953 30.9894 2.56623 -0.427284 6.89615 -5908 4 30.7531 12.7948 31.5295 -11.6926 9.48208 -25.7239 -5909 4 30.1452 13.1242 30.0532 3.97045 -7.90132 21.6369 -5910 6 24.0654 16.1863 40.3478 -8.57837 -16.1993 -7.0618 -5911 4 23.8181 16.8167 40.9886 -17.7345 17.1107 43.7161 -5912 4 24.4461 16.799 39.7307 8.03288 -6.21636 -19.956 -5913 6 21.8775 29.9129 12.7438 8.38993 20.3936 0.69825 -5914 4 21.1101 29.6022 12.2761 -16.411 -9.00989 -4.05561 -5915 4 21.7959 30.8814 12.6689 6.66677 -10.3308 5.74649 -5916 6 45.2196 12.276 6.62528 -23.2047 44.1078 30.1736 -5917 4 45.4494 11.529 6.11864 16.0879 -27.9404 -20.133 -5918 4 45.9267 12.944 6.63915 -2.18395 -9.27911 -10.7446 -5919 6 7.59043 25.3914 38.0243 42.7544 -18.087 21.3587 -5920 4 8.2454 25.1294 37.3073 -28.6085 13.3538 22.5553 -5921 4 8.06078 25.1795 38.9036 -17.5445 13.8955 -36.9473 -5922 6 46.1702 7.81994 16.6869 -21.8749 40.0263 -11.2018 -5923 4 46.5308 7.86296 15.7811 2.96678 -6.7279 9.6444 -5924 4 46.6568 7.20863 17.2067 24.29 -27.7199 6.2944 -5925 6 54.9712 12.8519 7.72645 -5.0392 -7.84126 -11.592 -5926 4 54.9715 13.8156 7.65436 -3.45199 -1.13943 9.08655 -5927 4 54.3111 12.5688 8.37934 8.51313 12.0297 -0.864167 -5928 6 26.936 39.6495 37.1759 1.87165 14.912 18.6021 -5929 4 27.6928 39.6002 36.5592 -3.34619 -10.0228 14.3716 -5930 4 27.1866 39.3914 38.108 -0.832196 -0.678219 -33.4669 -5931 6 27.0349 8.92218 38.0169 24.6524 -2.61622 -28.7715 -5932 4 26.316 9.52058 38.1337 -23.9094 17.4181 8.51603 -5933 4 27.4852 9.31616 37.2255 -4.7843 -14.0734 18.554 -5934 6 8.05135 7.65161 29.9116 12.1299 -7.94147 21.2544 -5935 4 8.62851 7.92802 30.6495 -6.35395 -5.29094 -12.0163 -5936 4 7.74814 8.47335 29.5547 -5.2558 18.4649 -14.2469 -5937 6 27.8737 27.8565 12.1051 -38.6038 15.3188 22.9885 -5938 4 27.4445 28.7122 12.3849 14.7215 -19.9621 -4.23437 -5939 4 28.6312 28.0341 11.5799 28.6137 10.9177 -18.1106 -5940 6 23.5548 30.5037 38.1558 -29.4871 -31.9475 26.5081 -5941 4 24.0962 30.758 38.9126 3.93335 7.76671 -5.43794 -5942 4 23.9417 30.8351 37.3772 21.2145 16.4773 -23.4003 -5943 6 48.0793 24.306 17.3344 -19.3615 12.8085 -14.3801 -5944 4 47.2872 24.7421 17.7455 27.359 -7.68532 -3.4425 -5945 4 48.1537 24.7387 16.4546 -0.580236 -6.90317 13.1114 -5946 6 38.498 5.30294 40.3305 40.7021 23.5094 2.62433 -5947 4 38.9475 4.64687 39.7972 -10.9193 -18.4764 2.07144 -5948 4 39.1882 6.01706 40.3225 -28.8653 -3.92995 8.38836 -5949 6 31.2337 3.92695 33.7301 -2.6422 16.6026 -6.87478 -5950 4 31.7948 4.28658 33.0166 -2.97898 -8.44373 7.32517 -5951 4 31.5298 3.03423 33.9266 10.3473 -9.06319 -0.444766 -5952 6 41.2426 8.81864 38.1104 -4.47266 -7.82466 24.3448 -5953 4 41.0373 8.41451 38.9755 -2.01902 1.52645 -10.1427 -5954 4 41.1368 9.75783 38.3095 7.23604 3.04516 -5.74389 -5955 6 53.3619 29.0937 24.5785 -40.2757 11.297 7.14485 -5956 4 52.5565 28.5537 24.7901 26.871 10.2044 -0.818821 -5957 4 52.9453 29.9599 24.3491 20.4755 -15.9472 -3.03 -5958 6 54.9044 15.544 40.7081 25.545 -57.3548 17.1629 -5959 4 54.9892 16.405 40.3633 -12.4948 43.2864 -12.4113 -5960 4 54.018 15.2891 40.9908 -7.57666 14.2468 -5.0348 -5961 6 46.3994 17.0672 31.8767 -6.245 16.1286 -17.5712 -5962 4 46.5114 17.9797 31.5283 3.34232 -11.2714 9.55259 -5963 4 45.8128 16.6602 31.1996 2.74349 5.02824 21.6551 -5964 6 36.898 25.0477 23.0493 11.3229 21.4084 -39.4528 -5965 4 37.2029 24.9737 23.9235 7.13326 -1.42781 43.2733 -5966 4 36.3025 24.3424 22.8486 -15.8402 -9.5757 6.36085 -5967 6 11.3692 4.41343 15.9249 15.7896 22.4119 -17.7964 -5968 4 11.3725 3.62473 15.3598 -3.28732 1.6252 14.2587 -5969 4 11.7055 5.11941 15.3214 -6.01385 -9.48847 12.8461 -5970 6 12.7845 7.07125 19.464 -10.6801 6.56169 22.7508 -5971 4 12.8604 6.27981 18.9655 14.1597 -21.8558 -24.6024 -5972 4 12.2771 6.71627 20.2197 6.8185 19.6013 -8.61559 -5973 6 12.0681 33.6471 17.5522 -1.52085 -17.496 -42.1785 -5974 4 11.9445 34.1189 18.3508 -6.25092 12.897 34.2466 -5975 4 12.5251 32.8183 17.7704 2.9394 6.95993 4.68875 -5976 6 10.2419 4.74292 2.55933 22.7613 10.361 1.71337 -5977 4 9.42389 4.50476 2.9876 -9.73314 -9.75152 7.74431 -5978 4 10.9687 4.12007 2.82053 -14.8261 2.90481 -11.2179 -5979 6 4.58785 36.8771 12.1606 -7.79451 -50.5455 -28.0593 -5980 4 4.4315 37.6675 12.6216 -0.588552 45.9766 17.7929 -5981 4 5.40236 36.9214 11.6472 0.781205 5.58305 7.99313 -5982 6 30.7591 35.3322 25.8391 -38.6972 -6.70904 -25.8809 -5983 4 31.308 35.3014 26.6139 2.09136 -3.6723 11.5509 -5984 4 29.8922 34.8696 26.0006 25.0535 4.09477 3.57125 -5985 6 20.1826 7.15897 1.87495 42.3449 13.1453 -15.8992 -5986 4 20.9155 6.54161 2.14653 -26.0098 16.5163 -6.36728 -5987 4 20.7109 7.92751 1.4772 -24.8109 -25.5601 12.7141 -5988 6 21.7554 6.89613 28.9929 -8.55274 -2.37394 -9.1913 -5989 4 22.0764 7.2366 29.8207 3.60587 3.07422 19.5812 -5990 4 22.5251 6.52709 28.5653 7.82832 -0.878326 -6.51175 -5991 6 6.87782 37.1389 6.94163 -1.13334 10.8563 13.3375 -5992 4 7.36847 37.9928 6.7949 -15.2779 -15.8129 7.53623 -5993 4 6.56156 37.0941 7.87645 12.8328 8.43507 -22.3513 -5994 6 37.1951 18.3599 16.3051 31.8484 54.3956 -63.0636 -5995 4 36.5686 18.6502 16.9278 -28.3708 4.63663 38.6073 -5996 4 37.3394 19.2548 15.8115 -3.93301 -42.965 18.1753 -5997 6 52.3874 25.498 31.3134 14.111 8.09505 3.74503 -5998 4 52.2596 26.4307 31.6656 16.8187 -33.1452 -9.3176 -5999 4 53.3531 25.244 31.2999 -24.6813 13.8962 6.4969 -6000 6 3.93514 39.8328 16.38 27.5969 -10.0907 -6.6773 -6001 4 3.11618 39.8354 16.8714 -5.56329 -11.6849 3.14974 -6002 4 4.25813 38.8985 16.2148 -16.7217 35.1377 3.93655 -6003 6 26.055 14.6352 18.3097 2.48745 23.0231 -5.4837 -6004 4 27.0121 14.5315 18.422 -4.58232 5.3017 0.111087 -6005 4 25.8831 15.6122 18.2324 0.591934 -25.1482 1.36918 -6006 6 22.1861 39.625 23.6336 -13.0035 -7.16992 22.0669 -6007 4 22.5756 40.4198 23.3178 20.0241 20.7615 -16.9022 -6008 4 21.775 39.9577 24.4575 2.36146 -17.5943 -7.81238 -6009 6 5.9827 12.8747 22.3739 5.28791 3.19174 -0.347139 -6010 4 6.16079 13.1981 21.4813 -0.557605 -0.80783 -0.954564 -6011 4 6.85402 12.6686 22.7296 5.64669 -4.60509 -1.11135 -6012 6 48.9358 28.1656 34.7093 -34.12 -15.1013 -7.57113 -6013 4 48.3009 27.4712 34.4428 -1.24475 21.7165 7.07681 -6014 4 49.7483 27.6911 34.6564 33.1581 1.27133 3.59264 -6015 6 7.76665 22.4378 33.2356 5.82113 4.36953 2.134 -6016 4 7.99414 22.0593 34.0982 -2.05459 -3.4103 -7.93698 -6017 4 7.15982 21.8587 32.7652 -2.05153 -2.03416 7.79212 -6018 6 41.0903 39.5994 11.7192 28.8485 25.6095 5.96672 -6019 4 40.6961 40.3697 11.3388 -29.9964 5.48828 -17.7316 -6020 4 41.854 40.0697 12.1081 -2.33823 -21.5528 5.66509 -6021 6 26.8801 37.922 39.3457 -9.67122 -13.15 30.7983 -6022 4 27.1418 37.9976 40.2903 -3.7646 7.48977 -14.0985 -6023 4 25.9915 37.5069 39.4007 11.6973 7.1772 -10.1587 -6024 6 16.8317 41.5399 16.7862 15.0313 6.40425 17.7164 -6025 4 17.5506 0.178386 16.4567 -5.24562 -1.69226 -13.3924 -6026 4 17.0965 41.4441 17.7156 -14.9292 -9.12078 -7.2801 -6027 6 19.02 8.9948 17.6728 1.01249 -20.0254 27.6053 -6028 4 18.8256 9.92734 17.8397 -2.50665 -0.780218 3.94781 -6029 4 19.0722 8.45531 18.5284 1.63313 22.2167 -34.6872 -6030 6 31.0993 24.379 20.1031 -5.45136 7.30173 -0.0135243 -6031 4 30.58 24.6604 20.88 7.69136 -4.59203 -13.2888 -6032 4 31.7465 25.0718 19.9526 0.652083 2.88804 -0.364555 -6033 6 24.6121 6.3117 27.596 -14.2942 3.47042 8.51555 -6034 4 24.6855 6.72112 26.7154 0.000835906 -11.6728 3.52597 -6035 4 24.4562 5.35726 27.5796 2.29956 0.742888 -9.80031 -6036 6 11.6309 5.33579 8.21245 48.3472 17.5789 -13.0214 -6037 4 10.7447 5.097 8.35577 -43.9811 -8.24091 9.59422 -6038 4 11.6324 6.14291 7.66014 -5.62825 -15.0071 6.92232 -6039 6 16.4828 34.2339 17.2467 58.9453 43.3211 -11.1422 -6040 4 15.833 34.737 16.7643 -22.9367 -4.06405 -2.05249 -6041 4 17.323 34.8225 17.0684 -41.083 -49.3458 15.3182 -6042 6 40.7431 40.4645 8.52128 12.2314 -11.8005 -21.5431 -6043 4 40.0246 40.6751 9.09883 -14.9736 5.2464 12.3608 -6044 4 40.4244 39.6664 8.05294 5.87539 10.603 6.78918 -6045 6 42.7463 5.87875 14.2877 12.74 -3.29305 -3.26541 -6046 4 42.0588 5.87807 14.9272 -15.1719 8.11415 20.4154 -6047 4 42.5132 5.11812 13.7588 -0.0411089 -3.23222 -11.0769 -6048 6 14.3659 21.065 6.06718 -46.5802 14.1632 25.7131 -6049 4 14.5381 21.6726 6.80844 -4.55135 -9.99097 -5.53618 -6050 4 15.2049 20.8313 5.76105 45.2018 -10.2131 -22.6687 -6051 6 16.2987 37.772 18.1217 -43.41 26.7654 24.2454 -6052 4 15.4242 38.2299 18.3727 36.2216 -25.3097 -28.3843 -6053 4 16.6845 37.7048 19.001 13.5629 -5.49997 -6.41318 -6054 6 40.7915 27.7152 27.1158 9.45156 2.81801 -4.91689 -6055 4 41.5456 27.319 27.566 -3.53201 -5.16081 10.0516 -6056 4 41.2155 28.2976 26.4751 -4.07016 3.79859 -1.40954 -6057 6 44.9595 25.9846 14.0499 3.3218 -15.4841 -8.79479 -6058 4 45.329 25.1566 13.6433 -5.22711 26.2877 13.1546 -6059 4 45.4837 26.7406 13.7529 4.37393 -9.76715 -6.45081 -6060 6 2.62066 33.9505 21.2427 -16.9582 -3.86849 -3.69815 -6061 4 2.06211 34.7496 21.3041 9.37305 -3.74186 4.79914 -6062 4 2.1388 33.3568 20.6382 5.47892 10.3925 4.65279 -6063 6 5.77806 4.43691 12.8378 4.70319 28.9306 -8.8144 -6064 4 5.36233 3.72198 13.3221 -5.81749 -8.58488 4.20714 -6065 4 5.80863 5.24637 13.3804 -1.3041 -13.5761 2.8333 -6066 6 16.8665 5.92021 7.40582 23.56 -3.08178 3.03829 -6067 4 16.4354 5.08697 7.20958 -2.89912 -12.7512 -7.28137 -6068 4 16.1638 6.54304 7.4701 -21.737 13.5702 4.65232 -6069 6 17.8259 38.4084 36.8446 -8.45971 28.6621 19.1884 -6070 4 17.7005 39.3712 37.0468 11.155 -18.7052 -15.1769 -6071 4 18.5325 38.3077 36.2071 4.43545 2.51623 -4.89916 -6072 6 43.3084 20.5973 5.4325 -39.7754 20.35 -2.23031 -6073 4 43.0204 21.5105 5.15286 19.9417 -23.843 3.70329 -6074 4 42.4274 20.1471 5.43024 22.0601 -2.53082 1.71294 -6075 6 21.5318 23.3 30.4444 10.3709 20.0389 -42.3415 -6076 4 21.0369 22.9394 31.1576 -20.9289 -4.03021 22.2109 -6077 4 20.911 23.6578 29.7428 10.7798 -15.246 22.7192 -6078 6 0.249866 28.0345 36.1724 -10.1983 37.6035 -27.6546 -6079 4 1.05324 27.7572 36.576 20.3102 -14.8665 16.9966 -6080 4 0.540234 28.832 35.6712 -10.982 -12.5736 6.41543 -6081 6 3.04754 17.0516 11.5683 -6.97145 7.64509 -15.3824 -6082 4 3.16434 17.3061 12.4746 3.36597 -0.550097 20.9912 -6083 4 2.52404 17.7798 11.2137 2.91457 -3.72579 -4.7217 -6084 6 24.1788 37.0366 23.9551 -12.9856 4.64226 12.2764 -6085 4 23.6099 37.826 23.831 6.85326 -8.75197 5.00341 -6086 4 24.4012 36.9865 24.9175 -1.53567 3.17074 -21.6248 -6087 6 3.95494 20.5134 27.4915 2.8093 53.7214 17.1103 -6088 4 3.58105 20.0931 26.7551 -14.7022 -26.8908 -38.8522 -6089 4 3.8118 21.4686 27.2477 5.25372 -20.6261 11.8203 -6090 6 54.8404 2.77723 29.6182 19.2518 19.5174 31.7291 -6091 4 54.8688 2.43537 30.559 -2.71579 12.5717 -24.6672 -6092 4 0.596183 3.44189 29.5911 -17.1059 -25.2514 0.407437 -6093 6 27.1931 8.41834 31.7378 -5.45838 77.4793 -29.1542 -6094 4 26.7872 8.25949 30.8671 -2.01983 -12.8877 1.93898 -6095 4 27.4107 9.43311 31.6496 -7.24897 -56.0438 21.5563 -6096 6 30.967 1.65521 30.3853 -24.4372 0.252197 19.6085 -6097 4 30.699 0.824835 30.0215 -2.04196 -23.8902 -26.6583 -6098 4 30.1085 1.94064 30.7387 6.28416 6.26069 6.0985 -6099 6 26.4053 36.4472 36.8445 23.7132 4.61357 6.55265 -6100 4 26.2095 35.8808 36.1068 -5.45287 -5.64468 -12.8873 -6101 4 27.3732 36.593 36.8324 -14.4493 2.44748 -3.93886 -6102 6 51.2993 10.0458 21.7014 24.6671 -30.2423 2.93053 -6103 4 50.7417 9.318 22.0589 9.26734 22.884 -6.07289 -6104 4 52.1551 9.59094 21.4448 -31.6711 18.7199 5.84467 -6105 6 52.4308 12.3792 23.2584 -6.42579 27.1004 22.8118 -6106 4 51.6946 13.0394 23.3088 16.6887 -7.91574 -6.77392 -6107 4 52.0327 11.5757 22.9611 -11.4365 -20.1199 -14.9439 -6108 6 9.99751 38.3699 20.6117 28.0449 -1.18219 -11.795 -6109 4 9.42862 38.2366 21.3654 -6.81781 0.619005 12.6857 -6110 4 10.9196 38.1916 20.8926 -11.789 -1.89114 -3.31064 -6111 6 22.7111 33.2651 0.632604 -8.26324 25.0772 17.5737 -6112 4 23.6702 33.3984 0.628432 0.752102 -10.2993 -4.51528 -6113 4 22.4939 32.4115 0.275412 2.14165 -18.6843 -11.1325 -6114 6 14.0859 40.8716 25.4956 -8.46488 1.55142 -11.4693 -6115 4 14.0599 40.7138 26.4427 12.1567 0.227551 5.06398 -6116 4 13.2623 40.45 25.1949 6.8133 8.32038 -2.55804 -6117 6 42.7734 15.0947 14.9538 14.4784 5.50426 -3.8277 -6118 4 43.0583 15.7694 14.2817 -8.42225 -24.0175 22.033 -6119 4 41.8405 15.2241 15.1238 -9.70916 3.613 0.791575 -6120 6 30.2327 7.231 8.54228 -3.22532 10.2874 -46.9304 -6121 4 30.2058 8.2102 8.45082 -0.363858 -13.9116 11.7844 -6122 4 30.4404 6.92219 9.39771 6.32383 2.81905 38.5597 -6123 6 3.37293 19.847 41.3038 28.0406 -0.792001 0.268463 -6124 4 3.19157 19.2836 40.5407 -0.0866071 4.98821 -2.30354 -6125 4 4.34764 20.0104 41.227 -24.6382 -4.50526 4.46777 -6126 6 8.87233 25.1482 17.2024 12.9182 -25.3276 -29.7935 -6127 4 8.99656 24.7585 16.2934 -10.9438 23.5455 20.5923 -6128 4 9.70028 24.8859 17.6216 -4.47076 0.166054 9.91948 -6129 6 9.34357 14.9539 22.0324 -26.1912 3.45279 3.87325 -6130 4 9.00509 14.8035 22.9321 4.97494 4.93375 -7.4516 -6131 4 10.1685 14.4775 21.9786 8.71262 0.391972 2.49596 -6132 6 2.03472 4.77693 20.8549 -5.0231 -16.4156 -4.2241 -6133 4 2.70086 5.4497 20.9192 18.9425 7.91266 2.94425 -6134 4 1.28907 5.15394 21.3146 -15.2358 3.90158 4.43282 -6135 6 18.286 7.04631 3.85489 -3.97091 0.415968 51.7005 -6136 4 18.7541 7.10917 3.04736 31.918 9.65669 -29.8899 -6137 4 18.8529 6.48913 4.44789 -12.6499 14.6692 -9.5202 -6138 6 17.0004 19.1661 19.8445 11.8294 -6.56912 -12.2376 -6139 4 17.7808 18.891 19.3473 0.445698 5.6808 3.33406 -6140 4 16.3387 18.5282 19.5337 -1.78106 12.0244 12.6463 -6141 6 4.30992 6.55322 21.357 27.1319 -4.11604 -15.0588 -6142 4 4.37542 6.91771 20.4543 -7.8574 5.76294 11.3657 -6143 4 5.24976 6.29093 21.5457 -28.1422 4.34799 0.417434 -6144 6 20.7778 36.9247 35.6618 12.7574 4.02765 2.49936 -6145 4 20.2864 37.0887 34.8562 -7.2468 0.0429553 -2.15645 -6146 4 20.2346 36.372 36.2389 -2.87094 1.27188 3.61263 -6147 6 4.73067 15.0203 31.2359 -10.2649 -12.7571 22.9725 -6148 4 4.37694 14.8342 32.1428 11.1861 -2.73027 -21.4712 -6149 4 4.72677 15.9733 31.1768 1.84417 11.2425 -7.2724 -6150 6 2.35535 1.23403 17.5726 17.2813 12.9738 -21.7174 -6151 4 3.03402 1.36527 16.8495 -17.2186 -13.1695 22.3246 -6152 4 1.92973 2.10387 17.6452 0.590267 -7.80147 9.6411 -6153 6 34.6252 31.5686 19.7984 -1.60729 -4.66139 0.568696 -6154 4 34.8929 31.9422 18.9439 4.49305 -5.18782 4.12596 -6155 4 34.4714 32.3271 20.3758 -2.9002 2.23803 -3.07041 -6156 6 24.1913 21.6089 13.5036 44.4004 0.328862 15.9674 -6157 4 25.0757 21.8297 13.9142 -30.8821 -6.11275 -18.7564 -6158 4 23.5519 22.0563 14.035 -11.4749 15.2668 7.23318 -6159 6 37.218 41.0972 5.69166 19.5034 -37.5651 -15.7416 -6160 4 37.88 41.7374 5.923 7.59407 13.6828 5.23653 -6161 4 36.3807 41.3769 5.99879 -24.6171 21.3167 5.70938 -6162 6 8.42841 7.99247 20.2345 27.9918 -33.0924 -23.0682 -6163 4 9.34968 8.06233 20.5347 -4.8675 5.92304 8.61954 -6164 4 7.93058 8.66586 20.633 -20.9635 39.4709 23.1164 -6165 6 14.934 18.8758 36.75 17.7625 18.3313 11.0559 -6166 4 14.0949 19.1945 36.41 0.856939 4.31409 -3.77921 -6167 4 15.6034 19.6084 36.7133 -18.5855 -12.9909 -4.44137 -6168 6 43.9791 40.6449 18.6524 7.41508 -0.428335 24.9958 -6169 4 43.9624 40.7544 17.7052 -3.16787 6.2189 -16.8328 -6170 4 44.8981 40.8188 18.9384 -9.62798 -9.77666 -5.30663 -6171 6 33.7986 32.259 37.3472 -15.5926 9.65631 -28.1821 -6172 4 34.0274 32.2295 36.4014 -5.19534 3.83485 15.8105 -6173 4 34.1945 31.4931 37.7276 18.2887 -12.3889 13.4194 -6174 6 5.09973 29.2834 24.0252 13.8314 -2.01249 29.2407 -6175 4 5.66693 29.5091 24.8044 -5.06459 -6.54793 -18.8628 -6176 4 4.76417 30.1245 23.7257 -5.49348 12.2693 -6.11875 -6177 6 33.6015 36.4179 10.971 30.294 2.53226 6.78363 -6178 4 32.7735 36.2836 10.5343 -15.5054 6.45725 -2.01925 -6179 4 33.4383 36.5424 11.9099 -7.56878 -2.98124 3.33663 -6180 6 28.3001 33.6166 13.1114 -3.16981 -41.1231 7.22112 -6181 4 27.986 33.7275 12.219 -4.10441 9.98298 -8.29397 -6182 4 28.0891 32.6746 13.2632 10.0083 14.4728 2.55385 -6183 6 6.1623 19.0624 24.2873 5.31394 -11.2621 -36.8053 -6184 4 5.95503 19.8074 24.8143 -4.51254 28.8134 22.7686 -6185 4 6.28788 18.3114 24.8476 4.1007 -18.6743 20.2695 -6186 6 28.4211 19.9362 1.86305 -4.43245 7.71948 8.08869 -6187 4 28.5604 19.4518 1.05094 6.94613 -11.0067 -8.65768 -6188 4 29.2593 20.0693 2.30859 5.46778 1.78077 -4.74455 -6189 6 42.0505 23.9714 9.55892 6.22877 26.0941 -5.00732 -6190 4 42.391 23.8165 10.4395 -2.03908 -8.00084 11.8727 -6191 4 41.7886 23.1541 9.15249 -7.7641 -22.6922 2.79783 -6192 6 43.5253 7.315 27.4414 4.48568 -18.9578 -0.168547 -6193 4 42.7359 7.07504 27.9388 -6.2009 1.74131 6.88183 -6194 4 43.2052 7.88335 26.7439 -2.31843 16.2411 -9.46916 -6195 6 20.4956 32.9945 9.25625 -63.2008 -2.41398 62.3431 -6196 4 19.7614 32.7323 9.96384 46.0698 -1.29529 -42.5223 -6197 4 20.3338 33.9485 9.24422 8.88758 3.29294 -12.4302 -6198 6 38.0318 35.2729 15.9427 -5.10059 -23.3836 -5.94715 -6199 4 37.3995 34.9842 15.2568 2.89047 3.01243 8.00796 -6200 4 37.9835 34.6007 16.6396 -2.13864 4.37071 -5.14357 -6201 6 47.5248 20.8808 3.95546 13.1177 31.1209 27.8573 -6202 4 48.0834 21.3954 3.36869 -6.69878 -8.89675 -13.1919 -6203 4 47.6052 21.4353 4.7772 -13.2785 -23.1226 -13.8569 -6204 6 10.9875 31.6892 41.4239 15.5099 5.40423 7.74084 -6205 4 11.658 31.8708 40.7529 -4.12469 -5.30401 -0.84079 -6206 4 10.1343 31.6927 40.9879 -7.96504 0.77506 -5.12071 -6207 6 43.245 12.6563 2.56138 15.9633 -17.8577 -2.60545 -6208 4 42.9226 12.9752 3.38765 -12.1061 12.2594 19.7928 -6209 4 43.9805 12.0851 2.8659 -6.2276 8.95994 -12.8364 -6210 6 49.4104 25.4124 21.1593 7.68799 -7.2912 5.83542 -6211 4 50.1422 25.2884 20.5387 -8.96396 0.548785 -4.3756 -6212 4 48.9554 24.5515 21.2297 -0.219253 8.20777 -2.75058 -6213 6 1.96484 34.1377 26.4635 6.42117 -7.58108 12.8955 -6214 4 2.78995 33.6488 26.6876 -20.6965 7.00883 -11.752 -6215 4 1.22498 33.5087 26.4121 8.61724 -1.18295 0.134997 -6216 6 17.1337 20.8362 36.6743 -37.6695 15.6036 21.8376 -6217 4 16.9634 21.7284 37.0778 2.65776 -21.0237 -14.9647 -6218 4 18.0617 20.7108 36.604 32.6572 -5.60583 -3.13187 -6219 6 36.5992 10.9735 3.70439 10.6975 8.82737 -5.2901 -6220 4 35.7369 11.4094 3.76988 -2.71865 -0.136466 14.5734 -6221 4 36.9547 10.7712 4.57736 -11.0261 -1.49358 9.11508 -6222 6 14.2213 20.6732 21.973 14.9521 39.3927 -42.8738 -6223 4 13.9206 20.2439 21.1689 -11.1282 -8.72354 1.45028 -6224 4 14.6851 21.4628 21.5779 -7.13343 -24.0966 22.8635 -6225 6 33.9052 12.2539 9.56536 64.6676 -19.1083 -72.943 -6226 4 34.3898 11.482 9.88615 -11.1791 5.59008 13.1859 -6227 4 33.2619 12.5422 10.1406 -48.1209 12.4396 55.8498 -6228 6 21.8075 41.4938 2.15247 -4.53434 0.170379 -15.7872 -6229 4 22.04 41.6038 1.2069 -3.47083 0.972349 16.0219 -6230 4 22.4007 40.8419 2.51679 12.4955 -1.6466 3.58022 -6231 6 20.9241 10.4413 14.2084 23.7182 11.537 17.3335 -6232 4 21.6155 10.8692 14.7979 -25.0251 -17.572 -17.464 -6233 4 20.772 9.54041 14.5736 6.4121 16.6732 -7.22543 -6234 6 6.25992 4.45494 24.6446 -20.993 10.5392 9.58783 -6235 4 6.70633 4.20365 23.8452 17.869 -10.7134 -15.0213 -6236 4 5.71116 3.71075 24.9084 -2.77077 -5.20552 -8.90983 -6237 6 50.776 14.5967 23.4784 31.7068 8.96229 10.5861 -6238 4 51.3012 15.0259 24.1918 -10.5702 -1.89466 -14.6802 -6239 4 49.902 14.4731 23.8252 -15.4415 -8.6063 7.51113 -6240 6 52.7906 13.9066 9.67243 -4.11462 48.2741 -4.64476 -6241 4 52.8606 13.0389 9.99278 3.823 -46.6932 12.5875 -6242 4 51.8698 14.0585 9.47707 -15.983 -0.946523 -10.048 -6243 6 9.04475 2.0467 29.9184 -38.5307 -30.621 -19.1189 -6244 4 9.46565 2.82007 30.2002 17.3321 39.2201 17.0183 -6245 4 8.08016 2.26538 29.8177 25.0495 -3.86709 2.38687 -6246 6 7.14389 29.9898 26.2407 4.70582 -42.771 12.4286 -6247 4 6.53112 30.404 26.8495 -5.08686 4.52864 3.1398 -6248 4 7.41427 29.1442 26.7142 -2.42767 26.6911 -17.7681 -6249 6 49.1638 41.7413 14.3375 -4.64089 27.4779 2.19815 -6250 4 49.5241 41.3828 13.5134 1.94418 -6.50091 1.47491 -6251 4 49.3811 0.802946 14.3236 2.14399 -30.2019 -5.07663 -6252 6 5.64888 3.82667 19.1906 -2.72189 -11.1411 26.1263 -6253 4 5.18678 3.36179 19.9258 5.23606 10.5823 -14.7259 -6254 4 5.05621 3.82399 18.4509 -7.60985 1.79477 -11.7277 -6255 6 9.32681 35.8274 24.8975 3.55565 13.5922 8.51546 -6256 4 10.2018 35.8152 24.4762 -3.06017 -4.39849 2.56743 -6257 4 9.46171 36.417 25.6586 -3.66837 1.49938 -3.23358 -6258 6 53.0285 29.7558 11.5499 -7.83487 -2.48558 9.64451 -6259 4 53.3653 30.4407 10.9686 7.5475 4.44921 -4.95089 -6260 4 52.7971 30.2083 12.3783 3.5824 -3.07517 -4.75195 -6261 6 22.6104 9.96627 5.67467 11.8622 1.90434 48.3765 -6262 4 23.3836 10.3266 6.15809 -8.36646 -10.9093 -7.81297 -6263 4 22.6398 10.3769 4.83333 -6.21393 7.91547 -32.804 -6264 6 39.5293 19.6134 2.67969 28.3515 9.20962 14.5311 -6265 4 38.5781 19.5068 2.58618 5.24604 -11.8744 -9.9137 -6266 4 40.0367 19.3939 1.87869 -17.6459 -1.04308 -3.70363 -6267 6 45.0742 35.5802 7.80399 12.9966 -1.00157 -13.6899 -6268 4 45.1073 36.2582 8.46111 4.45786 22.5875 10.9896 -6269 4 44.5296 34.9182 8.21469 -15.7495 -15.8794 0.100297 -6270 6 29.7829 14.2459 9.96531 -11.2509 -10.5838 -6.95263 -6271 4 30.0063 14.1556 9.0247 4.7074 -2.26926 1.20969 -6272 4 28.8478 13.9409 10.004 20.3358 11.6689 4.42407 -6273 6 29.2532 30.1489 21.8872 -22.7358 8.41186 19.7293 -6274 4 29.1261 30.8351 21.2312 3.02893 4.58934 -9.48892 -6275 4 30.0577 29.6729 21.7506 17.9631 -9.68935 -13.2514 -6276 6 11.1028 18.8149 6.56446 12.6172 11.1172 -5.75863 -6277 4 11.2898 19.7306 6.3073 -12.9819 2.38317 -1.53669 -6278 4 11.9922 18.4416 6.57196 0.724871 -8.7617 2.86424 -6279 6 13.403 39.1446 13.4748 19.5871 -11.9429 -30.0571 -6280 4 13.7697 39.8507 13.9939 7.8117 10.5151 13.4831 -6281 4 12.6292 38.8582 13.9386 -20.2152 -7.12839 8.32373 -6282 6 50.1432 12.9893 0.138872 33.4511 24.3017 64.4039 -6283 4 49.8497 12.6921 41.2405 -20.6967 -26.8999 -59.7452 -6284 4 50.7523 12.3231 0.503203 -9.52656 2.062 -3.94446 -6285 6 47.8312 31.3446 27.7846 -28.8076 12.8422 -13.2841 -6286 4 47.8833 31.94 28.5222 10.4006 4.03183 17.8143 -6287 4 46.9755 31.6479 27.4044 17.0933 -18.1054 -4.43643 -6288 6 27.7087 1.63781 7.50008 21.5285 -7.57238 -25.6841 -6289 4 26.9556 1.59549 8.05597 -25.0455 5.22958 17.9803 -6290 4 27.5166 0.963037 6.82134 -2.90509 7.89899 -0.0646572 -6291 6 54.8922 20.8 16.0331 4.1789 -41.4982 -7.93337 -6292 4 54.9282 20.9554 16.9716 0.186425 8.83729 15.9831 -6293 4 0.211633 19.8495 15.948 -9.91253 29.0383 -5.43741 -6294 6 37.4291 33.0056 34.4398 -14.0977 10.8622 -7.94924 -6295 4 37.2978 32.0826 34.6133 -1.58878 -21.6351 7.1631 -6296 4 36.5764 33.2755 34.0173 17.7258 4.45123 10.3439 -6297 6 19.5104 39.7742 6.7506 5.90241 -38.4201 -4.61078 -6298 4 19.1293 39.2182 6.01225 10.8403 19.9531 16.5545 -6299 4 19.9162 39.0938 7.35425 -12.9804 24.3225 -11.3083 -6300 6 32.4399 2.72699 8.06906 17.0773 23.4006 1.78158 -6301 4 32.9347 3.14941 8.81642 -19.9733 -16.2934 -9.37408 -6302 4 31.5531 2.49842 8.37658 0.516726 -6.41942 5.39598 -6303 6 12.9757 16.0915 4.06618 3.48233 -26.1302 -11.2272 -6304 4 12.5744 15.6527 4.83433 -0.695682 4.00385 -3.98901 -6305 4 13.3513 15.3473 3.55621 -4.30287 11.2057 5.6128 -6306 6 4.64677 29.9233 5.42983 -10.8182 14.2385 -56.8973 -6307 4 4.99957 30.1958 4.52107 -6.90737 -7.02982 36.161 -6308 4 3.86081 29.3683 5.18005 29.0195 11.7205 17.0104 -6309 6 29.7541 32.1122 24.0662 13.5325 13.0696 7.67536 -6310 4 30.657 32.2311 24.4313 -14.6232 -5.62961 -5.85099 -6311 4 29.8358 31.5529 23.3009 -2.99915 -14.1964 -7.88188 -6312 6 11.8689 30.6971 33.4711 -8.01032 -39.2081 28.7873 -6313 4 11.8961 29.8478 34.0479 -0.904256 41.1124 -29.4381 -6314 4 12.7288 30.7703 33.0546 6.62137 -3.78113 1.33903 -6315 6 17.3676 40.4123 27.3051 45.9752 30.8726 -27.1152 -6316 4 17.3095 41.3718 27.4557 -2.78012 -6.90788 -0.219066 -6317 4 16.6513 39.9873 27.6906 -54.0346 -15.2197 27.4879 -6318 6 8.66734 4.89901 8.93063 6.14116 -5.58058 -4.6479 -6319 4 8.35347 5.40804 8.18272 -1.2331 1.82325 -6.13974 -6320 4 8.16334 5.22925 9.67691 0.199365 1.34734 7.84993 -6321 6 39.5604 17.6833 9.57201 22.5105 -50.1639 -23.667 -6322 4 39.2658 17.6048 10.464 -10.5204 8.51393 23.2154 -6323 4 39.725 16.7168 9.31019 -10.6666 45.7312 -1.86495 -6324 6 31.4955 30.1755 28.5516 10.628 -19.507 17.1882 -6325 4 32.3525 30.3948 28.1778 -6.71462 8.32315 -8.11857 -6326 4 31.74 29.3729 29.0438 -14.9082 5.37925 -0.357203 -6327 6 52.6685 19.2672 40.0663 9.25056 16.4026 -20.0757 -6328 4 53.0106 18.7322 39.321 -9.61724 -4.6138 17.4516 -6329 4 53.0677 20.1385 39.8955 -5.74465 0.792691 -1.74468 -6330 6 3.24164 7.81666 9.85998 28.0429 9.66948 1.15728 -6331 4 3.83019 8.53432 10.2304 -23.9275 -17.8293 -12.7584 -6332 4 3.84853 7.29279 9.3074 -9.38214 5.4782 3.90821 -6333 6 23.129 35.218 35.5945 -25.4929 1.01472 15.9258 -6334 4 23.7784 35.3391 34.9359 33.2897 3.00284 -24.4901 -6335 4 22.5015 35.9398 35.4197 -4.85807 -5.03855 8.29984 -6336 6 19.51 14.0653 20.8221 -35.7596 -3.44758 -1.61502 -6337 4 19.8587 14.4985 21.6011 13.4146 6.44294 7.16022 -6338 4 18.5274 14.0852 20.9637 18.4505 -1.93413 -5.69736 -6339 6 23.6205 15.8624 24.0207 6.44012 -27.6666 -1.73497 -6340 4 23.7023 16.8084 24.0387 5.71305 22.1977 -2.17526 -6341 4 24.4604 15.4749 23.6823 -15.4387 15.2983 3.34328 -6342 6 0.280487 30.496 6.10097 2.10248 14.5258 38.6463 -6343 4 54.969 30.1752 5.28655 -5.78718 -18.1599 -43.8305 -6344 4 54.4568 30.8162 6.51538 2.11893 2.60892 6.09244 -6345 6 4.88818 13.213 29.1211 -10.1066 -44.834 -24.7823 -6346 4 4.81121 13.8494 29.7943 -5.77674 34.7781 35.8081 -6347 4 5.65875 13.4519 28.6173 14.302 5.76116 -10.624 -6348 6 54.2113 27.2762 19.1921 -15.5686 -30.3542 31.9917 -6349 4 0.068746 27.3681 19.6083 11.8738 0.793184 4.88761 -6350 4 54.2438 27.8077 18.4285 0.565084 22.1088 -37.313 -6351 6 13.9147 35.7477 9.19539 -9.45761 -42.0549 -30.4782 -6352 4 13.6498 35.0288 8.53341 12.0253 23.1831 27.3793 -6353 4 13.9217 36.5134 8.63033 3.91359 16.7787 -6.83247 -6354 6 5.91895 31.9062 18.8199 -10.5522 26.6577 -12.1166 -6355 4 5.59368 32.8276 18.7738 -3.70357 -9.82177 15.0022 -6356 4 6.3357 31.8271 17.9661 5.53766 -12.0386 -9.76018 -6357 6 5.80079 28.8629 9.48582 -4.23387 2.66619 -7.91216 -6358 4 5.1492 29.3316 10.0156 -4.194 3.81529 3.65919 -6359 4 5.26808 28.2356 8.96551 5.75879 5.11243 0.385299 -6360 6 40.1186 6.06288 9.7252 27.6823 -14.9678 -34.8134 -6361 4 40.0604 6.61837 8.91786 -4.97866 -6.72317 19.9534 -6362 4 40.8451 5.41953 9.46609 -26.5422 19.2978 14.9684 -6363 6 20.3249 13.4665 41.4109 48.5393 0.491453 -34.6424 -6364 4 21.248 13.7047 41.7262 -35.6043 -9.97545 -2.58991 -6365 4 20.4078 13.625 40.4256 -17.6073 -2.89865 23.6593 -6366 6 14.4355 21.7431 27.3521 26.8888 -5.93952 12.1752 -6367 4 15.3929 21.7238 27.5426 -15.4302 4.65814 3.66232 -6368 4 14.4086 21.5632 26.4128 -6.38145 3.02673 -3.91912 -6369 6 38.7552 1.80385 30.0529 11.0268 -28.3612 -27.359 -6370 4 38.4475 1.96331 30.9218 -11.1335 10.8767 32.3314 -6371 4 38.864 2.66369 29.6567 5.01485 14.1269 -3.82072 -6372 6 5.6038 10.8537 14.1812 -8.02182 -19.6512 10.0037 -6373 4 4.967 11.5707 14.1035 -3.71772 1.30399 -2.93081 -6374 4 5.11243 10.0991 14.6 11.6474 17.9462 -13.8385 -6375 6 45.4185 36.7135 27.9228 -18.8199 18.417 -42.2307 -6376 4 46.0687 36.7087 28.6222 8.21134 6.27257 3.16342 -6377 4 45.7172 37.2784 27.1471 -3.80026 -24.227 32.4306 -6378 6 54.0799 35.0377 20.3974 -0.144446 0.236923 -11.8112 -6379 4 53.8476 34.1116 20.536 0.519878 -4.41527 -2.37245 -6380 4 53.9532 35.2077 19.4441 0.866973 -0.817495 13.7238 -6381 6 42.0671 14.221 28.4749 -2.16655 -3.30611 3.54679 -6382 4 41.9442 13.9043 29.3971 9.00113 8.16851 -11.079 -6383 4 42.9986 14.4434 28.31 -2.56617 -4.72525 9.98454 -6384 6 34.845 7.68802 26.7053 1.50556 20.2543 7.34306 -6385 4 35.7046 7.39142 27.0344 -1.60005 -9.47728 3.59716 -6386 4 34.4934 7.05976 26.0702 4.4346 -10.8207 -3.70702 -6387 6 49.6605 30.7141 23.8514 -28.5275 -6.56067 -11.9374 -6388 4 50.4604 31.1934 23.8565 34.1351 17.5516 -0.640456 -6389 4 49.8146 29.9659 24.4072 5.37992 -19.8924 15.651 -6390 6 50.8948 7.80148 14.1671 21.5777 -12.9452 34.2787 -6391 4 50.8247 6.96775 13.7105 -4.99079 -12.0182 -18.7136 -6392 4 50.5655 8.51894 13.6572 -15.7049 17.9748 -24.3233 -6393 6 4.26893 39.4826 27.8512 8.9926 -8.51629 -1.47833 -6394 4 3.65831 40.2241 27.8513 -3.04259 7.34368 5.94949 -6395 4 4.00328 38.958 27.1013 -12.9816 -10.5728 -11.1653 -6396 6 8.75177 32.8341 8.22283 -21.5639 -30.1985 -34.1316 -6397 4 8.2383 32.1284 7.72694 10.6374 17.547 21.6449 -6398 4 8.83279 33.5372 7.56693 3.76401 9.53239 7.06969 -6399 6 52.9594 25.4882 9.38297 -25.0802 50.1357 20.0056 -6400 4 51.9882 25.4292 9.65119 35.7509 1.27265 -17.7678 -6401 4 53.158 26.4759 9.49827 -6.53976 -44.9947 -5.62964 -6402 6 29.5661 36.7256 19.4603 5.44621 -17.3757 32.4066 -6403 4 29.5786 37.3961 18.7906 9.88328 7.74732 -15.4263 -6404 4 30.4565 36.6309 19.8726 -14.3545 4.38723 -10.5986 -6405 6 52.3236 36.1013 25.1169 17.8415 -25.8683 -35.0149 -6406 4 52.9656 35.7372 25.71 20.0999 5.67458 7.00157 -6407 4 51.6595 36.4261 25.6714 -35.904 19.3861 23.0835 -6408 6 21.182 15.7103 31.1872 -18.8583 3.19523 -20.0756 -6409 4 20.6533 16.2005 30.5215 19.2403 -4.60119 13.454 -6410 4 20.518 15.2243 31.6931 2.46505 1.20146 2.10658 -6411 6 10.6569 22.4337 39.4531 2.51655 -26.4213 -37.4968 -6412 4 10.8327 22.4219 38.4645 -4.29248 9.16844 28.2769 -6413 4 10.2506 21.5589 39.6181 7.08653 12.2011 0.686531 -6414 6 25.1113 11.6729 22.7164 -12.9971 -0.576423 -18.0399 -6415 4 25.1382 11.4787 23.6279 21.2779 0.00518046 39.517 -6416 4 24.1824 11.5118 22.5586 2.84555 -0.272219 -17.8246 -6417 6 31.7896 10.4703 2.90217 -23.2712 -10.1944 -9.79051 -6418 4 32.6146 10.7499 3.28348 13.8778 6.97942 -8.99307 -6419 4 31.8394 10.4464 1.92418 10.0551 5.29594 18.2662 -6420 6 52.4849 36.4361 22.1663 -9.62786 -33.6069 5.21212 -6421 4 53.146 36.0606 21.5474 -12.5852 0.946736 4.3316 -6422 4 52.0694 35.6392 22.6209 17.7505 30.3514 -16.202 -6423 6 46.2093 40.0329 26.9877 0.0297183 29.9961 33.6049 -6424 4 46.4751 39.2742 26.5126 9.55695 -26.8643 -22.4205 -6425 4 45.9048 40.7092 26.3771 -3.76152 -2.91476 -3.34389 -6426 6 24.0885 36.7218 39.1011 7.12362 -3.16907 -4.80429 -6427 4 23.5999 35.9078 38.9667 11.8985 -11.6148 -5.9332 -6428 4 23.4559 37.2234 39.5891 -11.7402 16.6095 17.3029 -6429 6 22.3514 7.42547 31.8169 -35.2707 -41.8068 15.3628 -6430 4 22.2213 8.33277 32.0647 5.94025 21.3422 4.40196 -6431 4 21.6465 6.92073 32.3398 32.1745 21.6054 -24.7594 -6432 6 14.3502 18.3597 4.09728 -2.0055 -9.38358 23.348 -6433 4 14.1099 17.4219 3.93107 -0.92654 19.6042 10.3569 -6434 4 14.0726 18.5364 5.03654 13.0175 -10.3464 -23.9346 -6435 6 27.3175 38.46 0.124188 33.1007 -9.911 1.68747 -6436 4 26.9395 39.2806 0.463932 -4.88512 2.40457 5.81864 -6437 4 28.2608 38.413 0.45438 -35.2324 2.96259 -2.16122 -6438 6 18.6695 0.162292 12.2239 -43.166 1.81748 26.3235 -6439 4 17.7303 0.262878 12.5713 26.4571 2.30278 -22.2908 -6440 4 18.9433 41.3202 12.7499 8.63834 -11.46 6.42912 -6441 6 49.423 24.9792 25.3382 20.605 1.42964 -0.346179 -6442 4 48.5484 24.7002 25.6009 -12.613 -0.556076 -3.92373 -6443 4 49.3508 25.8032 24.8352 -9.8769 -5.62219 -3.2466 -6444 6 52.0685 20.2858 15.7446 -45.9435 -8.75518 14.7384 -6445 4 52.9731 20.5149 15.783 39.268 6.79994 2.42829 -6446 4 51.7449 20.2597 16.6676 4.81444 3.79951 -9.92674 -6447 6 49.6576 15.6472 38.4942 19.425 -17.6129 -0.00729052 -6448 4 49.2099 16.0165 37.7231 -6.98596 1.36616 -1.50856 -6449 4 49.5102 16.1958 39.2633 -14.7214 13.7889 5.58845 -6450 6 15.9211 23.7235 13.4193 23.3289 -36.8815 11.3263 -6451 4 16.506 23.7025 14.2147 -19.633 8.70021 -19.3267 -6452 4 15.5217 24.5725 13.2813 -7.62789 19.6624 11.7876 -6453 6 14.3566 29.1635 14.3074 -12.0826 22.9902 -11.8551 -6454 4 14.1263 29.6193 13.4563 6.10678 -19.1115 21.2229 -6455 4 14.1254 29.8374 14.9735 4.9154 -5.66101 -4.10969 -6456 6 30.4264 19.8612 16.8883 21.8822 -42.1222 -1.02119 -6457 4 30.7186 19.5182 17.7453 7.89699 4.38367 -1.56912 -6458 4 29.8579 20.5689 17.0557 -25.7709 36.069 4.20145 -6459 6 21.3137 21.0352 23.1207 17.1515 -0.95565 24.203 -6460 4 22.2175 21.149 23.495 -16.5785 2.35003 -9.75668 -6461 4 20.7278 21.0809 23.8918 1.9436 3.71589 -4.02445 -6462 6 32.3543 0.425745 25.2542 2.91189 -3.53517 -15.1456 -6463 4 32.2281 0.339162 24.2978 10.7775 -1.18886 4.59452 -6464 4 31.5305 0.792307 25.5362 -21.0885 6.89421 14.2132 -6465 6 26.144 32.4145 27.5224 1.5207 15.2147 0.716215 -6466 4 25.5792 33.1636 27.3089 1.00017 8.92672 2.49827 -6467 4 25.8737 31.7446 26.908 1.40169 -15.6227 -12.5261 -6468 6 31.6924 23.0038 41.4488 2.9891 4.25247 18.5975 -6469 4 32.5817 22.7219 41.7427 -10.6129 2.19465 -7.80737 -6470 4 31.0787 22.7203 0.234806 2.54762 2.31931 -6.22567 -6471 6 54.3675 17.8383 10.7129 6.79577 23.0573 52.4548 -6472 4 53.55 18.2477 10.4428 -14.1319 6.62767 -11.4304 -6473 4 54.6119 17.1874 10.0964 4.54612 -26.2874 -33.1105 -6474 6 15.4111 28.5567 8.624 -23.5209 17.7221 -14.2225 -6475 4 14.7074 29.0083 8.07604 23.4242 -18.2482 9.63627 -6476 4 15.9053 27.9212 8.07642 -10.4486 8.35345 -4.07335 -6477 6 21.923 22.3267 27.6697 4.39763 -15.072 3.90508 -6478 4 22.0757 23.261 27.7591 9.36727 14.8743 -6.39222 -6479 4 22.0153 22.013 28.5729 -4.02641 -8.91923 4.38679 -6480 6 2.936 17.0367 8.13301 26.8737 -0.816539 -9.93732 -6481 4 3.80704 17.1417 7.69888 -17.5309 -13.2134 -6.39661 -6482 4 2.90872 17.8246 8.6543 -8.08771 15.2208 15.3377 -6483 6 27.578 18.2783 3.98106 42.3665 -21.0645 -7.59535 -6484 4 26.9838 18.9866 3.87461 -35.9411 25.5305 -3.32845 -6485 4 28.3853 18.6252 3.56495 -11.0807 -10.9366 8.58166 -6486 6 24.7671 24.5333 8.4671 -3.55267 7.94183 -11.8318 -6487 4 25.0347 23.6359 8.24775 3.17664 -3.45343 1.13667 -6488 4 24.5725 24.5372 9.40731 3.34714 4.39373 0.466573 -6489 6 41.9868 30.4684 13.7801 28.6364 -21.7839 2.09937 -6490 4 42.9472 30.4515 13.6527 -5.43777 20.4489 -0.76134 -6491 4 41.8419 29.5153 13.705 -23.7897 6.87836 6.63004 -6492 6 15.6883 34.6775 41.5701 28.3539 0.757195 5.77675 -6493 4 16.4499 35.2822 41.5481 -1.40988 -1.74654 9.10263 -6494 4 14.9914 35.2483 41.869 -21.9895 7.57474 1.73196 -6495 6 11.1473 19.7636 40.5906 -7.01786 -3.24743 -12.0486 -6496 4 12.0915 19.8265 40.3679 -7.75233 -10.0339 3.8807 -6497 4 10.7912 18.9088 40.243 10.6872 10.1147 9.9033 -6498 6 47.4955 34.5311 14.2936 14.7321 -31.661 -1.66099 -6499 4 46.9342 35.3117 14.2317 -6.87541 2.2103 -19.2779 -6500 4 47.4978 33.9137 13.4978 -3.14061 27.4792 16.9676 -6501 6 12.3981 26.9866 28.4861 26.5251 -74.1409 -7.08463 -6502 4 13.226 26.8461 29.0045 -10.1246 11.0422 -0.548558 -6503 4 12.3843 26.0988 27.9797 -6.45597 45.1087 15.272 -6504 6 27.6352 16.207 39.8297 -11.2321 14.8168 6.13397 -6505 4 27.2166 15.4175 40.1567 -13.0977 -6.13948 14.8525 -6506 4 28.2209 15.8539 39.184 23.7477 -3.37658 -20.6816 -6507 6 33.4012 31.2187 27.2758 -9.34358 5.5086 -22.6345 -6508 4 34.125 31.7676 27.5967 0.31405 7.14405 -9.79506 -6509 4 32.8978 31.7031 26.5666 21.3968 -7.09575 17.214 -6510 6 39.0983 39.5786 31.9234 0.802497 -2.15341 -0.194752 -6511 4 38.8245 39.6381 30.9898 -0.836727 0.773065 10.2743 -6512 4 38.5517 40.2102 32.4207 8.13236 -5.11153 -2.10971 -6513 6 22.8875 16.5662 19.9556 -18.6429 -47.4181 0.677292 -6514 4 23.2714 15.7467 20.3471 4.73069 19.3315 1.98369 -6515 4 22.0725 16.1814 19.5628 10.6014 14.9969 -2.71875 -6516 6 23.9725 21.8734 10.5896 -27.2099 14.1239 -19.8382 -6517 4 22.9807 21.8764 10.5048 23.1264 -0.860286 11.7265 -6518 4 24.1883 21.166 11.1844 -1.51334 -13.3572 20.4185 -6519 6 40.1791 25.4384 2.79385 3.27033 10.4385 -27.7191 -6520 4 40.1215 24.9503 3.60378 -1.57927 -2.0951 21.761 -6521 4 39.8421 26.3422 2.89187 -4.34677 -6.39915 11.9951 -6522 6 15.0222 19.7637 9.4145 -47.1416 28.5942 15.5409 -6523 4 14.7277 20.7258 9.2944 13.9352 -33.0223 -5.4956 -6524 4 14.1981 19.3167 9.80349 37.3596 11.4933 -12.2096 -6525 6 7.16734 24.8761 0.122492 -38.9593 -14.3052 4.78001 -6526 4 7.92262 24.7355 41.4818 28.9246 2.82935 -8.29154 -6527 4 7.37325 25.3267 0.937782 12.1222 2.94845 5.10402 -6528 6 43.395 10.8961 31.3295 35.6095 27.14 14.9602 -6529 4 43.8689 11.0333 30.4778 -14.9331 -12.4968 13.4948 -6530 4 44.125 11.0026 32.0067 -24.5429 -5.74221 -22.764 -6531 6 13.8447 19.0699 27.8622 -3.35019 15.2359 -6.83255 -6532 4 12.9833 18.7163 28.0985 -4.55464 1.4506 5.93475 -6533 4 13.7874 20.0538 27.8435 3.60016 -14.5834 0.921784 -6534 6 3.48728 19.5892 9.61273 -55.7314 7.48447 -10.4955 -6535 4 2.69835 20.0905 9.96963 22.9021 -19.0673 -4.76373 -6536 4 4.2501 19.9102 10.0538 23.4289 5.03115 15.3445 -6537 6 51.0169 19.4212 7.7195 26.3048 39.1054 -53.7154 -6538 4 50.748 20.2575 7.21364 -2.7273 -32.3506 28.7892 -6539 4 51.8579 19.2204 7.21263 -29.2082 -7.0208 18.9647 -6540 6 42.2149 2.6091 10.4112 25.8935 -20.0624 -18.8025 -6541 4 43.1623 2.45904 10.6444 -24.152 11.2038 4.82319 -6542 4 42.1853 2.33112 9.4647 -3.80011 10.6068 21.7004 -6543 6 30.7928 6.43901 35.1986 -21.6247 -20.8821 1.11778 -6544 4 29.8295 6.39304 35.3716 10.0359 5.79706 -2.44011 -6545 4 31.0478 5.50645 35.0814 0.649811 9.90023 -1.69835 -6546 6 52.8722 36.96 18.5947 9.01539 9.27494 -7.55423 -6547 4 52.0657 36.4448 18.5061 -12.9065 3.13675 2.3407 -6548 4 52.6935 37.8522 18.2226 2.03776 -15.609 7.12003 -6549 6 44.2018 6.29599 1.04883 9.29405 17.1768 7.51252 -6550 4 44.5044 7.06671 1.58929 -4.49779 -17.4812 -0.431191 -6551 4 44.952 6.10526 0.487985 -0.115844 -2.61588 -3.46335 -6552 6 42.1326 38.6047 31.1849 18.5327 -13.3283 33.8135 -6553 4 41.7834 38.9864 30.4106 -14.9936 10.8543 -35.8121 -6554 4 41.4904 38.8324 31.8627 -0.641051 1.33351 1.93 -6555 6 43.7219 12.8013 9.05519 -6.282 7.91343 -40.7352 -6556 4 43.3171 13.69 8.87718 10.3632 -22.6116 8.3507 -6557 4 43.9578 12.415 8.15014 1.61383 14.3586 37.3488 -6558 6 13.4062 0.438838 6.51561 -30.6084 29.4042 -0.600484 -6559 4 12.9719 1.14899 7.05573 20.0807 -17.3818 -8.1595 -6560 4 13.3782 0.782754 5.59696 2.59294 -3.03922 8.63079 -6561 6 16.1217 13.2907 10.2805 -3.10591 -25.3511 -12.454 -6562 4 16.8946 12.7568 10.5076 8.02861 4.25978 2.86397 -6563 4 15.5299 12.6092 9.88546 -0.135156 17.9383 7.81515 -6564 6 1.59113 8.48217 4.69745 0.410151 -22.2633 16.3582 -6565 4 1.97054 9.1194 4.11301 8.92831 16.113 -22.7699 -6566 4 2.26765 8.43533 5.38895 -6.97239 3.0759 6.50405 -6567 6 37.2935 1.72102 10.5172 -13.7439 -9.21578 15.0824 -6568 4 37.1042 2.64553 10.595 10.0955 20.4226 -13.0857 -6569 4 36.8105 1.41855 11.2983 8.13599 -13.5394 -0.658926 -6570 6 53.8411 9.88961 17.6933 -45.7386 -38.9159 3.57486 -6571 4 54.5353 10.0399 17.0846 27.4782 6.59889 -23.5339 -6572 4 53.3721 9.08338 17.329 10.482 22.3983 14.0606 -6573 6 45.4787 30.6173 15.8038 -24.3966 -4.27047 13.1326 -6574 4 44.7717 31.1876 16.1963 22.3351 -9.42651 -10.1125 -6575 4 45.1907 29.6979 15.9324 6.84487 10.052 -2.21901 -6576 6 39.9241 16.6394 33.8426 -26.8877 -6.37158 -14.218 -6577 4 39.1549 17.2016 33.5476 23.291 -18.1751 3.42158 -6578 4 39.818 15.753 33.3934 2.94846 26.4583 15.0268 -6579 6 32.8532 24.7638 27.9368 9.55773 21.8346 -14.3088 -6580 4 33.6229 25.0593 28.4772 -14.6217 4.84572 -15.4057 -6581 4 32.6055 25.4822 27.2751 14.9958 -18.2832 35.5187 -6582 6 7.86628 31.6164 24.1091 22.2934 14.9204 62.1634 -6583 4 7.77595 30.8628 24.7489 -5.82572 16.0022 -25.8365 -6584 4 8.17309 32.3545 24.746 -24.9312 -26.1857 -42.8493 -6585 6 43.5324 41.3356 15.8165 16.5067 -5.02973 0.188395 -6586 4 43.1944 0.320073 15.7896 -5.69638 5.43212 -4.38793 -6587 4 44.429 41.3992 15.443 -10.6291 -2.88383 0.315207 -6588 6 20.021 29.5505 33.1902 25.0419 -7.98688 14.3875 -6589 4 20.8911 29.4069 33.5992 2.6372 -12.3274 -8.42754 -6590 4 19.6576 30.1636 33.8147 -14.9588 14.7065 -0.197692 -6591 6 43.4056 21.4569 18.6265 10.2156 -2.1017 15.5441 -6592 4 43.0498 21.3696 19.5313 -0.699705 -7.60676 -10.3888 -6593 4 42.9844 20.831 18.0298 -12.2248 -1.50447 0.773582 -6594 6 3.43117 19.1215 18.408 34.3393 4.70286 11.768 -6595 4 3.22621 20.0564 18.4267 -2.18643 4.81974 -5.59269 -6596 4 2.60088 18.6799 18.3703 -20.3233 -14.3491 -1.28903 -6597 6 41.6742 38.1112 16.3299 0.384784 -42.0766 -46.2559 -6598 4 41.8939 37.3404 15.6708 -9.75075 44.1094 34.3099 -6599 4 42.3403 38.1083 17.0131 5.25517 -2.87066 6.28124 -6600 6 7.56339 36.3915 10.5048 -18.8567 -13.4705 -13.5944 -6601 4 6.70677 36.1596 10.0967 9.18231 15.0261 0.193132 -6602 4 7.92251 35.493 10.5558 6.04756 10.3771 12.1048 -6603 6 36.2642 19.1103 34.8187 -40.4108 -29.7457 -43.4097 -6604 4 35.4719 19.3187 34.2477 20.3247 -4.92751 27.2967 -6605 4 36.4213 19.8813 35.3193 7.80254 33.8099 20.7293 -6606 6 53.576 24.9483 12.6399 1.20561 -0.517111 -17.326 -6607 4 53.6619 25.9414 12.669 8.79141 -29.2645 -7.24265 -6608 4 53.913 24.5623 11.7782 -4.09912 18.2899 28.1509 -6609 6 31.6824 10.4618 21.0892 -21.9557 -25.3726 -8.81809 -6610 4 31.4281 9.67391 21.5915 5.84781 10.5911 6.7189 -6611 4 30.8909 10.5838 20.5303 11.506 8.60894 0.332243 -6612 6 18.1093 28.7861 17.1823 13.2379 18.2354 -13.1758 -6613 4 19.074 28.7105 16.9739 -24.5165 5.38082 5.29014 -6614 4 17.7652 29.607 16.728 11.5472 -26.6353 13.0333 -6615 6 21.6834 18.2239 36.88 17.2587 0.811675 -5.67627 -6616 4 22.5671 18.027 36.4721 -27.7349 -1.55215 19.1593 -6617 4 21.6367 17.7543 37.7464 -1.70499 5.95625 -12.509 -6618 6 25.0551 19.0348 34.2287 -62.1041 -5.07763 23.2016 -6619 4 24.7663 18.3443 34.8719 5.43786 16.9757 -10.9409 -6620 4 25.8827 18.7578 33.9618 64.2031 -27.8273 -22.1538 -6621 6 15.5709 13.019 5.5539 0.00735057 -17.6807 20.5563 -6622 4 15.9927 13.3293 6.36292 0.0692085 12.4919 -5.39058 -6623 4 15.4491 12.0681 5.73828 -2.05735 13.2604 -17.7033 -6624 6 54.47 41.6402 14.7959 12.609 -13.6787 23.2741 -6625 4 54.8097 41.4531 15.6947 -1.45983 11.4249 -10.5768 -6626 4 53.7709 40.9948 14.7271 -15.6812 0.146288 -8.92901 -6627 6 1.6639 26.4809 31.3827 12.672 -25.15 69.1319 -6628 4 2.55491 26.3764 31.7735 -12.447 -0.333387 -5.00094 -6629 4 1.81595 26.6127 30.4938 10.6163 16.8649 -70.5286 -6630 6 32.3417 37.2868 29.6843 -28.8191 13.9029 5.49332 -6631 4 31.5776 37.8992 29.8843 22.0104 -18.6347 -4.04342 -6632 4 33.1171 37.6855 30.0945 4.79121 1.59444 1.77014 -6633 6 52.7104 21.0422 22.8867 -25.9211 15.4876 17.6965 -6634 4 51.8895 21.5407 22.5959 27.9099 -16.7396 2.24416 -6635 4 53.1785 20.6742 22.1421 1.33026 -7.16251 -14.9349 -6636 6 32.7465 28.5808 40.5193 19.5614 -2.95666 4.13778 -6637 4 32.1272 29.2507 40.2236 -19.1805 -2.02865 5.11045 -6638 4 32.5793 28.3106 41.4408 -7.78706 5.87783 -13.0149 -6639 6 23.6078 32.0654 16.3528 6.52471 10.7856 29.7964 -6640 4 24.3701 32.0729 16.9793 -11.8963 -10.2614 -20.8491 -6641 4 22.8856 32.382 16.9256 -1.99185 -7.37994 -15.8659 -6642 6 37.5296 9.17182 29.9714 -32.9897 5.30306 10.5453 -6643 4 36.7716 8.86544 30.5111 15.5785 -5.70066 -5.7121 -6644 4 37.1221 9.9689 29.5744 15.1662 -5.45151 -1.53858 -6645 6 2.26386 24.3835 14.5546 6.71022 -7.72281 -24.2479 -6646 4 1.85963 24.0133 15.3587 -6.19133 3.33276 -9.20692 -6647 4 2.05254 23.8227 13.7642 -0.610841 12.6744 29.5344 -6648 6 27.3686 28.7935 24.7702 8.50672 -13.2399 -34.495 -6649 4 27.2338 28.4442 25.6457 -6.20833 -8.14759 12.6395 -6650 4 27.3624 28.0447 24.1031 3.25167 21.2409 25.246 -6651 6 16.785 2.54959 14.3094 -6.20571 44.0359 18.8502 -6652 4 17.7332 2.53792 14.3228 12.8455 -14.2273 -3.64568 -6653 4 16.4133 1.8101 13.8617 -1.35631 -25.1723 -17.3636 -6654 6 21.8048 39.8028 36.8143 34.4281 41.1875 6.43987 -6655 4 22.7768 39.6281 36.9504 -24.2083 -5.20947 -5.56999 -6656 4 21.4132 39.0119 36.5213 -11.0202 -42.2818 -12.3994 -6657 6 14.0639 6.48367 41.5586 -1.33856 -25.5903 -39.7582 -6658 4 14.9412 6.10051 41.3922 2.86672 3.38346 15.7648 -6659 4 14.0719 7.05039 0.399753 4.3465 12.2327 22.8772 -6660 6 14.5548 16.5075 9.32956 22.0841 -14.7784 -21.2506 -6661 4 15.3586 16.5914 9.87503 -6.36199 2.72911 -6.08794 -6662 4 13.8899 17.0883 9.65711 -8.71884 14.1475 23.1102 -6663 6 8.67066 23.4815 30.5556 -44.0195 -7.59097 13.7496 -6664 4 9.49671 23.6557 30.1334 33.8338 1.75787 0.0184994 -6665 4 8.69311 23.4014 31.5307 16.0679 1.7618 -7.5699 -6666 6 37.6567 2.07706 19.9993 -10.7882 4.4912 14.9507 -6667 4 36.977 2.26584 19.3592 -1.31755 -8.36894 -24.369 -6668 4 37.311 2.65872 20.6865 17.7477 -2.01295 10.0374 -6669 6 42.7201 7.55732 8.02256 37.7013 -31.8103 68.6738 -6670 4 43.2078 7.90139 7.31041 13.9641 18.3531 -33.1003 -6671 4 43.4713 7.36984 8.74143 -54.3005 13.1784 -34.8973 -6672 6 38.5678 29.6657 6.85728 10.4727 -7.97498 12.0381 -6673 4 38.5138 29.2192 7.70857 5.95943 6.40388 2.63109 -6674 4 37.7242 29.471 6.47402 -15.8477 4.38345 -15.5494 -6675 6 42.5297 15.7017 39.7864 -1.2311 2.72873 2.24862 -6676 4 42.7877 16.6334 39.6476 -7.55712 -4.9727 -7.52807 -6677 4 42.0746 15.3358 38.9963 17.4435 12.5166 7.69263 -6678 6 19.8571 7.43592 22.0545 -24.1472 -5.51637 33.4113 -6679 4 19.2244 8.12179 21.7601 9.35088 -5.78158 -2.10146 -6680 4 19.4596 7.11536 22.9248 14.2781 17.6372 -34.9907 -6681 6 27.4149 3.22069 12.5516 40.9266 14.4549 -35.8463 -6682 4 28.3021 3.29229 12.0821 -30.0356 5.19144 18.8294 -6683 4 27.3767 2.28812 12.7581 -5.67627 -4.82192 6.74426 -6684 6 34.4116 6.50186 34.3661 -21.9879 -4.07114 7.78674 -6685 4 33.6675 7.13398 34.4265 8.52018 -4.33452 -1.60522 -6686 4 34.0848 5.70903 34.842 8.55338 12.1797 -0.556276 -6687 6 9.89342 27.9558 39.7643 36.6491 -8.46867 13.0669 -6688 4 10.8456 28.0225 40.104 -41.9626 -4.51635 -15.7261 -6689 4 9.67004 28.8098 39.3873 2.34979 10.3628 -2.65954 -6690 6 50.5619 22.115 6.39208 17.1303 26.4748 31.0688 -6691 4 51.4904 22.4109 6.45725 -8.74694 -11.3909 -7.00891 -6692 4 50.1939 22.6078 7.15954 -8.62199 -11.7106 -16.757 -6693 6 47.1151 11.4881 30.0373 19.0993 -20.4412 31.5796 -6694 4 47.2481 10.8506 30.7795 8.25865 21.4973 -13.9376 -6695 4 46.3269 11.1564 29.6474 -26.9131 -5.13028 -17.9745 -6696 6 25.9416 28.4741 9.79918 -11.6773 -32.55 32.2578 -6697 4 26.8348 28.2861 10.1548 -13.4597 2.20587 -7.83095 -6698 4 25.3328 27.8368 10.2912 20.3964 27.2145 -12.4741 -6699 6 35.4384 36.5941 19.4416 12.9267 19.1414 22.694 -6700 4 35.4164 36.6623 20.432 -0.885856 -8.21646 -20.3497 -6701 4 36.1159 37.2681 19.2232 -9.51806 -6.29836 -4.59986 -6702 6 39.0948 17.8654 12.2958 16.402 12.2899 -6.89152 -6703 4 39.0474 18.8007 12.5965 -2.38328 -10.6878 -1.40665 -6704 4 38.4419 17.3626 12.7715 -16.1853 0.319976 14.0097 -6705 6 2.67108 27.1436 2.40101 -1.75759 -3.65761 -8.1759 -6706 4 1.9876 27.5644 1.84788 8.2175 -2.76418 4.2561 -6707 4 2.53155 27.392 3.3289 1.87867 -1.67129 -3.85288 -6708 6 12.3359 32.2055 21.5153 -21.7508 0.12991 31.168 -6709 4 12.6488 32.0797 22.4173 29.0853 13.2861 -13.6486 -6710 4 11.491 31.8094 21.7155 -17.148 -0.720271 -25.2422 -6711 6 32.8833 32.3716 8.45599 -19.6455 -21.472 -14.5807 -6712 4 33.4538 32.8256 9.05859 9.48117 21.6574 11.6239 -6713 4 31.9723 32.7028 8.50155 9.17651 3.82723 3.41156 -6714 6 12.6485 6.44458 31.9777 -6.29944 1.49663 15.4125 -6715 4 13.1578 6.35833 31.1835 12.9638 -3.65534 -14.9347 -6716 4 11.7474 6.25334 31.7296 -4.07419 -1.29291 -2.47195 -6717 6 41.3645 27.7433 14.0415 -6.01814 -18.8263 -25.007 -6718 4 41.8124 27.3175 13.2596 -11.5333 15.588 22.1217 -6719 4 40.3975 27.5756 13.9407 20.5065 3.01622 5.4742 -6720 6 6.60161 16.499 25.4489 9.93734 -1.87947 -15.8553 -6721 4 7.35848 15.8951 25.4583 3.3895 5.33583 -1.00098 -6722 4 6.02379 16.0419 24.8253 -6.53341 1.34025 8.2366 -6723 6 21.7786 39.2974 13.3607 -58.7317 27.2846 42.4257 -6724 4 22.3848 39.3902 12.6828 41.4687 -6.70168 -50.5194 -6725 4 21.6228 40.2371 13.624 5.27297 -27.3266 2.34771 -6726 6 34.8408 6.01319 6.94562 -18.4641 -1.51643 5.78804 -6727 4 33.8445 5.90926 6.91888 31.3517 2.57767 -4.40922 -6728 4 35.1545 6.28252 6.0657 -8.54142 -2.93715 0.97402 -6729 6 33.0232 30.4151 33.1713 -30.7469 -3.39927 -39.9685 -6730 4 32.1382 30.6983 32.7963 25.7009 -18.3352 9.36685 -6731 4 33.1108 30.988 33.8978 7.7837 23.494 30.6115 -6732 6 15.4491 32.4129 12.2013 37.3068 -21.1945 16.3611 -6733 4 16.3823 32.073 12.2446 -28.3662 8.39135 1.47263 -6734 4 15.4224 32.8258 11.3561 0.313824 15.5191 -23.5701 -6735 6 12.6648 26.6033 21.3782 33.3074 -46.6123 -64.9668 -6736 4 12.0344 25.8976 21.5501 -12.6652 14.4466 17.403 -6737 4 12.7392 27.3327 21.935 -15.9008 39.2731 46.5109 -6738 6 47.0171 36.3051 29.9756 -14.9097 -3.99946 59.7783 -6739 4 47.3887 37.0247 30.5306 -0.120183 -5.44251 -19.0377 -6740 4 46.4147 35.8463 30.6463 22.302 11.6315 -30.1098 -6741 6 0.299553 12.7005 23.3858 -50.0817 10.3486 20.6993 -6742 4 0.55843 11.8154 23.133 6.9712 -0.709946 -9.28769 -6743 4 54.2783 12.6185 23.429 39.7411 7.62342 -2.706 -6744 6 54.1651 18.9185 21.5773 -27.3575 7.2555 -32.8787 -6745 4 0.055729 18.801 21.8215 42.2187 -10.4087 33.76 -6746 4 54.2632 18.7361 20.6344 -21.3012 2.13243 0.141772 -6747 6 25.7162 24.2884 23.7449 23.2111 -33.139 -2.25213 -6748 4 25.1836 23.5617 23.2944 18.61 24.747 21.927 -6749 4 26.5708 23.8587 24.0884 -36.4232 14.4676 -16.0896 -6750 6 11.8952 29.0236 26.8796 9.31073 -5.31833 9.58593 -6751 4 12.582 29.6684 27.1204 -3.01706 -1.21814 -5.31042 -6752 4 12.0145 28.319 27.5465 -5.16863 11.8863 -12.5997 -6753 6 48.0052 35.8598 10.6996 -18.0426 -22.591 -32.4945 -6754 4 48.7896 35.6794 10.1443 -7.64403 10.0758 9.7343 -6755 4 48.2747 36.3464 11.4544 19.4818 11.8303 20.3364 -6756 6 47.6544 29.8545 36.9555 47.7155 -39.8456 -42.9298 -6757 4 48.1196 29.373 36.1789 -16.9409 17.9192 43.9777 -6758 4 46.9556 30.2951 36.4995 -17.6283 12.0501 3.0439 -6759 6 7.32865 12.3513 10.6225 -20.3459 13.1064 -14.334 -6760 4 7.20572 12.8267 9.76478 7.03806 -14.4953 16.449 -6761 4 6.49136 12.5857 11.0944 24.1086 -12.0498 -8.15528 -6762 6 52.9256 15.9641 4.89737 -18.3283 -2.7411 -11.4996 -6763 4 53.001 16.1105 3.94443 2.36662 -0.713792 8.85774 -6764 4 53.8018 16.0105 5.25645 21.1817 2.44507 8.14275 -6765 6 10.6731 16.9472 34.6118 -36.7423 -4.99845 -47.4494 -6766 4 11.0533 16.8484 35.4724 -5.12202 -12.2675 26.0308 -6767 4 9.83371 16.4151 34.3796 40.245 18.7583 25.5995 -6768 6 25.147 31.0596 36.0152 -5.60145 -19.7687 -32.0201 -6769 4 25.7935 31.7656 36.1171 1.22463 2.78419 -3.72446 -6770 4 25.3418 30.5949 35.1615 -4.38154 15.6016 24.1358 -6771 6 34.0913 21.8858 41.4775 -4.76405 18.1665 32.5634 -6772 4 33.6625 21.1007 41.1787 -2.29922 -28.5955 -6.85504 -6773 4 34.6054 22.1733 40.7506 14.2114 10.2598 -30.2937 -6774 6 15.7731 30.0818 1.26798 39.0641 -13.3599 -49.0464 -6775 4 15.0823 30.4241 1.791 -23.818 19.5269 30.6537 -6776 4 16.2108 30.862 0.84325 -15.3415 -19.24 18.755 -6777 6 29.5302 27.8609 16.6022 -41.3972 -29.0796 28.0786 -6778 4 29.3307 26.8764 16.753 17.6765 42.2449 -1.67193 -6779 4 28.8227 28.3009 17.156 20.6394 -5.21731 -15.3441 -6780 6 39.6438 9.77612 0.552706 9.07327 13.2864 29.0584 -6781 4 40.129 10.5839 0.897097 -15.1313 -20.9808 -12.8857 -6782 4 39.4906 9.23066 1.36029 2.34479 9.54176 -15.0004 -6783 6 1.51524 31.8825 16.4089 -15.0842 0.567558 32.708 -6784 4 2.11225 32.2249 15.7721 17.5465 17.6302 -23.3114 -6785 4 1.56386 30.9485 16.2687 -0.663138 -25.5376 -6.36093 -6786 6 8.73078 39.8635 25.0545 2.96185 -34.7465 -17.9129 -6787 4 8.00321 39.5602 25.6169 4.07363 9.59654 5.53067 -6788 4 8.89391 40.7829 25.2096 -1.06312 24.7623 5.36493 -6789 6 42.3301 10.2778 9.76455 0.0249942 22.0437 -8.66619 -6790 4 42.035 10.1947 10.6715 6.68889 -4.55788 7.04955 -6791 4 42.6957 11.1854 9.68656 -1.85544 -15.7885 0.75259 -6792 6 13.241 7.61416 1.95847 -11.6175 -6.73398 30.6404 -6793 4 13.9892 7.82191 2.54806 -1.36929 5.6022 -7.80568 -6794 4 12.5695 7.22502 2.56499 11.7798 7.16895 -16.7116 -6795 6 18.7434 40.0583 14.2212 10.8937 -7.32712 21.4541 -6796 4 19.2417 39.7541 15.0131 -1.99408 15.6159 -18.1773 -6797 4 17.935 39.549 14.2832 -4.44855 -3.57314 -3.37042 -6798 6 20.0977 14.0454 38.5561 35.4799 -67.417 -7.49733 -6799 4 20.2641 13.632 37.67 -9.31749 10.6865 24.2255 -6800 4 19.7827 14.877 38.3297 -23.7972 64.5272 -8.60678 -6801 6 22.6565 28.8842 34.0588 -5.52315 8.37947 20.7951 -6802 4 23.0585 28.228 33.4828 2.77778 -4.34029 0.307399 -6803 4 22.9395 28.703 34.9822 0.354749 -6.57221 -14.6515 -6804 6 22.6874 4.70198 5.2328 -25.042 -9.90055 15.5414 -6805 4 22.1274 3.9708 5.56882 12.1557 -0.0327816 -16.8284 -6806 4 22.5434 5.31639 5.94822 12.9551 16.3877 4.62095 -6807 6 23.6492 33.9942 38.3998 23.375 33.8394 -43.1733 -6808 4 22.8011 33.6715 38.57 -44.227 -25.7371 21.164 -6809 4 23.4749 34.4069 37.5183 19.103 -7.547 16.6445 -6810 6 48.374 21.3549 17.2744 -0.727013 41.2048 -23.9838 -6811 4 48.2041 22.3166 17.0448 3.0192 -25.1475 26.0409 -6812 4 48.3509 20.9743 16.3868 -2.31832 -8.94154 10.8829 -6813 6 11.5758 10.9938 8.63273 -18.0621 42.8191 15.9647 -6814 4 11.6313 10.2483 9.25156 -2.19238 1.01339 1.87179 -6815 4 11.0547 11.7764 9.03291 21.9333 -36.8133 -6.7089 -6816 6 40.0924 28.1686 33.4857 17.1635 -5.37387 30.2378 -6817 4 41.046 28.3881 33.5354 -13.2006 -3.32107 -11.2861 -6818 4 39.7443 28.4933 32.6629 4.51627 6.28126 -11.3213 -6819 6 47.3837 25.6703 5.29617 28.7657 21.9065 -4.48206 -6820 4 46.461 25.5322 5.12569 -20.8862 2.51482 -4.893 -6821 4 47.6179 26.6114 5.08959 -12.3293 -15.1007 -0.275896 -6822 6 21.6517 35.2222 23.996 27.7917 10.3485 -3.89698 -6823 4 21.6311 34.5383 24.6593 -10.5502 -12.8786 6.64496 -6824 4 22.5954 35.4881 23.9966 -15.7417 2.23004 -2.6139 -6825 6 8.24409 41.4919 8.41354 9.22969 12.4334 -12.8549 -6826 4 8.15 40.8674 7.67873 -1.07657 -2.81584 5.48771 -6827 4 7.83543 41.113 9.18983 -1.52095 -3.2343 5.88405 -6828 6 16.4798 31.1082 22.2131 -4.24513 -17.8742 -2.35359 -6829 4 17.0752 30.8161 21.5077 -7.18137 4.28218 -7.0656 -6830 4 17.0564 31.1902 22.9696 5.97679 -0.907857 10.4567 -6831 6 54.7122 0.459271 28.3177 -16.7834 -37.5181 -6.57119 -6832 4 0.641958 0.15455 28.3975 4.09167 16.1916 -1.73275 -6833 4 54.5379 1.34634 28.6236 20.797 14.6923 4.72985 -6834 6 48.4477 15.3762 4.17752 -7.35125 -30.0531 -4.44848 -6835 4 49.1738 15.1128 4.81019 -14.8803 0.337287 -24.8229 -6836 4 48.0902 14.5922 3.6288 23.2827 31.0113 24.8784 -6837 6 34.3541 7.00171 40.4295 26.6588 -46.9533 -23.8625 -6838 4 33.6168 6.99428 39.8319 -14.4938 10.2897 -3.98371 -6839 4 34.9839 6.35967 39.9588 -19.3291 28.4488 24.7248 -6840 6 41.3507 3.37676 17.0028 -19.6969 -26.4955 -6.96819 -6841 4 41.02 2.66518 17.5936 5.53648 12.9859 -1.78552 -6842 4 41.944 3.90566 17.5305 10.5068 9.85924 8.73726 -6843 6 48.4427 20.685 14.5419 46.8112 -36.6841 26.4704 -6844 4 48.0177 21.3487 14.0717 -32.7597 47.8552 -32.6818 -6845 4 49.3877 20.9188 14.5227 -9.08294 -4.43462 -1.64124 -6846 6 52.4922 28.1277 37.1182 6.87418 8.84651 -10.3419 -6847 4 53.4134 28.4024 37.0408 3.12987 -6.6922 4.15316 -6848 4 52.2752 27.8963 36.2007 -7.47166 7.06161 9.73328 -6849 6 53.8774 18.5638 18.79 -18.2161 -77.5341 7.0005 -6850 4 54.7018 18.1425 18.5274 3.76082 -0.315502 -3.76089 -6851 4 54.0435 19.4528 18.7445 16.4561 77.5259 -2.54699 -6852 6 41.0011 39.1407 28.7879 -31.3786 -4.09579 71.7092 -6853 4 41.3911 39.2094 27.9661 28.9736 8.71878 -68.6315 -6854 4 40.0521 39.3021 28.7019 -2.27612 -3.41331 -6.23213 -6855 6 38.2743 8.75074 24.2285 24.5029 -7.68366 -19.8132 -6856 4 39.1919 8.60362 23.8621 -28.3827 4.68959 18.7737 -6857 4 38.3545 9.42009 24.9092 0.456349 2.35846 11.2764 -6858 6 2.99111 29.1615 9.6319 43.2691 -54.6401 14.341 -6859 4 2.5338 28.6319 8.99687 -12.0219 1.86489 -18.3516 -6860 4 2.58318 29.9865 9.638 -27.8835 49.5023 8.75508 -6861 6 27.5756 29.2755 18.3378 -4.01048 -11.7045 41.1881 -6862 4 26.7643 29.1652 17.8389 -11.7278 -2.11582 -9.62984 -6863 4 27.2839 29.0037 19.2864 20.9622 13.2114 -52.0932 -6864 6 11.8501 21.1733 10.1172 4.58733 -51.566 26.4002 -6865 4 12.2099 22.0246 9.9906 13.4732 33.828 -10.0235 -6866 4 12.4495 20.7458 10.776 -15.5727 16.0367 -15.8372 -6867 6 16.9004 32.2989 0.299881 0.133752 -22.2186 -6.7835 -6868 4 17.7029 32.7095 0.626455 9.4749 11.3588 3.4417 -6869 4 16.2118 32.9605 0.285394 -3.66285 20.1796 -4.1714 -6870 6 1.30064 17.4766 22.5523 32.9941 -5.4384 -19.965 -6871 4 1.2446 16.5356 22.2294 -6.1018 21.6977 3.5382 -6872 4 2.22906 17.8023 22.3815 -23.7878 -13.737 8.2324 -6873 6 41.5474 6.85538 29.3077 15.2611 30.5857 3.861 -6874 4 41.7413 5.96016 29.5642 -1.91107 -14.5726 0.121693 -6875 4 42.0251 7.37916 29.9826 -12.8279 -1.76094 -5.06557 -6876 6 10.5087 10.782 13.8577 27.0965 -13.6956 13.3978 -6877 4 10.7007 11.2274 13.0253 -2.16043 3.73872 -7.98734 -6878 4 11.2742 10.169 14.0479 -24.5023 11.0776 -3.5626 -6879 6 39.8289 15.4978 40.8346 25.2099 1.13818 0.661387 -6880 4 40.0487 16.0673 40.0758 -9.90377 -2.84048 2.34508 -6881 4 40.6829 15.4254 41.3222 -18.4618 6.82556 -4.74882 -6882 6 26.5164 19.6052 40.5088 -9.33805 1.61856 -11.7217 -6883 4 27.41 19.9717 40.4897 0.274496 -7.70925 5.49567 -6884 4 26.4209 18.9712 41.2422 6.64723 7.57269 5.06511 -6885 6 54.036 8.18782 13.7715 27.5212 34.9045 -2.54262 -6886 4 54.5316 7.46918 14.1378 9.61628 -19.3806 0.327355 -6887 4 53.1925 7.88218 13.5309 -39.9219 -15.1658 -7.5943 -6888 6 15.6949 25.3434 10.6718 -31.7842 -7.37099 0.0612328 -6889 4 15.1805 25.3333 9.84403 14.6699 1.30202 -4.92807 -6890 4 14.9666 25.3615 11.3188 15.8696 -4.15214 -3.47235 -6891 6 18.5987 3.44175 21.9294 71.7321 -9.69418 15.9409 -6892 4 19.6071 3.44542 22.1959 -64.1569 1.8736 -14.3483 -6893 4 18.6296 3.58776 20.9721 -7.77871 5.49431 4.81248 -6894 6 50.8883 20.6265 18.5187 28.1172 41.6529 17.9746 -6895 4 50.1573 21.1733 18.1958 -9.23125 -9.06144 -4.34911 -6896 4 51.4834 21.2842 19.0045 -23.468 -29.5191 -15.1667 -6897 6 53.3673 20.9038 31.2869 -12.1652 -1.18869 -3.23134 -6898 4 53.2409 20.9073 32.2442 5.88471 -1.70994 -0.407299 -6899 4 52.4717 20.8062 30.9053 11.2743 1.61965 3.90294 -6900 6 52.8102 27.6189 28.9831 -34.4743 -7.30027 30.0453 -6901 4 52.2848 27.4362 29.7987 1.4862 0.901255 -27.4551 -6902 4 53.4947 28.1361 29.3473 35.4934 25.3811 1.80223 -6903 6 33.3112 15.6955 11.3264 12.7704 9.00306 37.7013 -6904 4 33.4999 16.1238 12.2198 -3.00415 -23.4283 -28.8796 -6905 4 32.4346 16.0003 11.1059 -7.33456 8.94646 -4.12361 -6906 6 20.3875 26.8057 27.4813 21.213 -4.31231 15.2493 -6907 4 19.6396 27.3594 27.2578 -2.8557 9.66202 -0.370116 -6908 4 20.9667 27.2946 28.1279 -24.4059 -13.8952 -19.2793 -6909 6 8.54399 2.06163 14.1713 4.36483 17.1543 -0.299448 -6910 4 8.13837 1.20516 14.196 -9.47708 -17.773 2.17407 -6911 4 8.01805 2.60085 14.7902 6.78451 -6.83093 -3.12033 -6912 6 40.1002 7.56575 40.6778 12.4019 9.60944 38.6013 -6913 4 39.712 8.14959 41.3779 4.03526 -4.70584 -30.6789 -6914 4 40.8329 7.16354 41.1893 -8.78874 -6.51591 -16.4763 -6915 6 6.89044 6.83556 10.7869 16.1514 15.8461 -3.23426 -6916 4 7.31622 7.70217 10.5979 -16.164 -15.6489 3.8938 -6917 4 7.04178 6.69918 11.735 -3.2221 -0.411834 -4.21297 -6918 6 31.2643 6.58983 20.136 22.5576 -57.6677 6.94967 -6919 4 30.6637 5.92034 20.5005 -2.47046 2.78164 8.35653 -6920 4 30.7152 7.30056 19.9711 -35.0351 52.1138 -11.6241 -6921 6 54.5411 21.0454 27.2925 4.1013 -43.0328 84.8338 -6922 4 0.071192 20.2129 27.5399 -15.6737 30.1382 -21.2093 -6923 4 54.6532 21.3072 26.4181 12.1035 8.54749 -60.3726 -6924 6 4.75213 23.1508 16.2245 -49.4139 4.34438 -28.0546 -6925 4 4.2471 24.0009 16.1592 20.3634 -17.2761 5.59937 -6926 4 5.4972 23.3136 16.7675 27.2932 5.42097 22.4316 -6927 6 25.5515 11.0241 14.8358 9.2665 0.546345 5.2197 -6928 4 26.0976 10.3608 15.3182 -9.73323 12.0118 -14.516 -6929 4 25.8683 11.8947 15.1133 0.0398252 -5.90721 -2.6003 -6930 6 41.1974 41.7784 29.942 -27.7855 -7.97533 -10.6302 -6931 4 40.9203 40.8727 29.6366 8.3922 29.767 6.72032 -6932 4 40.4023 0.465719 29.8931 18.9924 -15.525 2.17149 -6933 6 52.2793 15.2936 41.6313 19.4314 -9.06844 -20.2837 -6934 4 51.991 15.9601 0.331443 -10.9307 10.9541 10.4228 -6935 4 51.6032 14.6231 41.5544 -13.8311 -6.7739 0.824233 -6936 6 37.7418 21.7882 37.8505 9.73059 24.2058 3.49681 -6937 4 37.8176 20.8655 37.6583 6.26781 -24.8638 0.142384 -6938 4 38.1128 21.8753 38.7352 0.661952 0.248137 2.40564 -6939 6 23.8436 9.73697 27.5598 -17.3101 -56.824 -21.1542 -6940 4 23.6823 8.97924 26.8635 13.0753 42.6322 38.797 -6941 4 23.3674 9.48178 28.3892 6.27388 8.11738 -19.7561 -6942 6 43.0121 28.0431 32.8137 29.5034 -18.022 1.83467 -6943 4 42.9555 27.148 33.1715 -16.7807 6.42622 4.12236 -6944 4 43.9561 28.0675 32.5908 -15.6612 14.0802 -2.62256 -6945 6 34.1451 21.2362 11.9042 -10.4207 -39.0944 -3.26361 -6946 4 33.7785 20.3444 12.1585 8.75301 27.3815 0.918114 -6947 4 33.7383 21.3833 11.0382 -2.92284 10.3561 2.31655 -6948 6 10.5016 31.8267 10.0873 5.91889 6.7472 5.74276 -6949 4 10.9186 32.6594 10.3946 -11.2895 -14.4825 -9.55855 -6950 4 9.99233 32.0033 9.274 9.03923 7.50024 8.93884 -6951 6 35.8744 37.1309 22.1208 9.07655 -0.20125 -37.6945 -6952 4 36.7757 37.5102 21.9868 -16.2539 -8.14962 7.83623 -6953 4 35.5893 37.243 23.0078 -0.963312 7.56509 34.0991 -6954 6 27.293 4.59192 27.4599 -62.9251 -2.97268 8.43797 -6955 4 27.8573 4.63875 28.2367 1.75868 -0.322614 6.7695 -6956 4 26.3027 4.46726 27.7774 60.9698 2.85981 -12.9146 -6957 6 39.0165 22.2861 10.6525 -25.2911 9.99335 20.5692 -6958 4 39.5938 21.9801 9.97437 16.8498 -5.94336 -19.6369 -6959 4 38.1468 22.3658 10.2352 2.38909 -7.32087 0.337973 -6960 6 30.765 39.1813 10.9358 -26.8864 17.0789 0.421318 -6961 4 31.7273 39.1993 11.0368 0.254075 -10.0442 -6.8497 -6962 4 30.3957 38.288 10.8473 24.5485 -0.522695 0.476538 -6963 6 44.5972 26.9475 2.20695 17.6159 -27.9211 -0.145864 -6964 4 44.8477 26.0903 2.61727 -13.9349 20.2639 -7.87324 -6965 4 45.3006 27.0404 1.55025 0.322606 15.9 1.66232 -6966 6 23.7817 14.549 26.4845 -13.1218 37.1912 -28.6876 -6967 4 23.5085 15.1786 25.7375 18.3344 -26.327 26.4977 -6968 4 23.2314 13.7794 26.3439 -3.10125 -8.02717 6.138 -6969 6 38.3349 13.3785 39.6531 51.0719 11.8768 18.627 -6970 4 39.1134 13.8424 40.1004 -28.3003 -20.0613 -21.9332 -6971 4 37.637 14.0102 39.7945 -20.9869 -1.09015 1.55638 -6972 6 17.9076 17.2343 29.3998 2.5182 -11.8623 9.07057 -6973 4 17.7005 16.8028 28.5679 -0.208052 -3.06359 -6.42367 -6974 4 17.2973 17.9612 29.4206 -13.3644 14.2602 6.84169 -6975 6 17.427 29.8312 9.9167 5.70667 9.14636 11.5297 -6976 4 16.5259 29.8398 9.63655 -18.5043 -5.93208 -2.5299 -6977 4 17.9097 29.6705 9.11934 16.3543 -3.78316 -10.6623 -6978 6 35.6302 6.05705 19.6249 -12.632 -1.17761 -30.1407 -6979 4 35.1756 5.57436 18.904 4.12491 -0.359791 14.6292 -6980 4 35.7342 6.9119 19.1826 9.40393 1.91765 12.7562 -6981 6 18.674 22.2857 17.523 8.42296 3.39096 21.1197 -6982 4 17.7402 22.4481 17.6821 -9.17854 0.615652 -6.61815 -6983 4 18.8674 22.3747 16.5992 -7.41694 3.44878 -20.9034 -6984 6 20.0258 3.81405 32.2871 -5.45876 10.2161 0.982716 -6985 4 19.684 4.03807 31.424 -2.67861 3.00481 -7.64614 -6986 4 20.9375 3.54321 32.099 -1.59169 -5.33194 9.42598 -6987 6 5.47094 6.98417 8.10987 -1.95658 -27.204 5.03178 -6988 4 5.85072 7.84658 8.088 3.96324 28.039 -6.11929 -6989 4 5.94584 6.55919 8.82772 -3.50663 -6.33739 10.9422 -6990 6 44.182 20.5312 25.5979 43.1361 -13.705 -19.148 -6991 4 44.6875 21.1042 26.1493 -15.9255 27.6084 29.7698 -6992 4 44.9726 20.2272 25.1253 -26.0739 -14.4287 -20.9555 -6993 6 43.9621 36.9892 17.8709 27.7049 17.1418 -9.42399 -6994 4 44.6647 37.4643 17.3692 -13.724 -4.61297 12.4448 -6995 4 43.6121 36.3808 17.225 -14.1002 -14.0328 0.985329 -6996 6 34.6183 10.1148 16.2555 -4.96303 14.2933 -37.1542 -6997 4 34.4099 10.1014 15.264 7.63186 -7.52385 38.4141 -6998 4 34.6455 11.0716 16.4378 1.03434 -4.81203 3.48645 -6999 6 23.6535 3.43617 1.32551 9.32991 -27.0385 -60.023 -7000 4 23.5361 2.47498 1.09872 1.70789 26.2755 24.74 -7001 4 23.8607 3.79652 0.414552 -11.3127 6.44054 37.9529 -7002 6 33.4225 38.9606 5.09116 -45.0556 15.9463 14.7537 -7003 4 32.9187 38.171 4.91655 10.2233 -24.4058 -4.43744 -7004 4 32.6531 39.5198 5.39063 34.9247 3.3662 -8.43025 -7005 6 22.5542 32.508 35.8091 -1.62577 21.6885 -22.4452 -7006 4 23.4313 32.1432 35.8321 13.5304 -8.64793 9.08541 -7007 4 22.6972 33.4304 35.4917 -7.91418 -12.6316 15.6694 -7008 6 32.4209 37.2696 13.8263 22.6153 37.4816 -15.7005 -7009 4 31.6314 36.8608 13.5507 -35.0264 -17.3769 -13.0658 -7010 4 32.7321 36.7183 14.5153 12.3601 -27.6025 17.2047 -7011 6 52.6048 12.7515 39.5965 -13.8302 -6.28036 -1.32475 -7012 4 53.26 13.3571 39.2655 9.70847 9.80763 -6.22213 -7013 4 53.0114 12.2827 40.3245 7.10516 -3.61819 3.538 -7014 6 28.8284 14.5654 1.23244 38.3097 18.383 -14.9432 -7015 4 28.2834 13.8143 1.34735 -23.3809 -22.0338 3.15251 -7016 4 28.3672 15.33 1.56727 -9.74512 0.414323 3.22557 -7017 6 1.45359 32.4205 23.3989 -1.05001 -40.1011 -18.1189 -7018 4 1.47013 31.5606 22.9188 -1.41837 10.7967 19.8874 -7019 4 1.97354 32.9442 22.8182 11.5552 29.203 -12.5869 -7020 6 54.3296 23.3325 28.9716 1.50467 4.34178 0.834044 -7021 4 54.2574 22.8567 29.7964 -0.193368 0.82753 11.1745 -7022 4 54.4723 22.6371 28.331 0.325397 -5.40149 -8.07104 -7023 6 14.3127 12.1509 35.6633 -33.5663 -10.8168 -13.6472 -7024 4 14.2878 12.7047 36.4184 6.74358 21.3133 20.6565 -7025 4 15.1756 11.8015 35.6107 35.8459 -8.25269 -4.05635 -7026 6 18.9986 6.53226 41.2771 -21.1361 -24.8418 -24.3627 -7027 4 18.366 5.78703 41.1105 9.63211 18.6573 18.8829 -7028 4 19.3119 6.48514 0.272589 3.11598 2.01554 11.5533 -7029 6 5.32991 17.8836 20.3428 -30.4167 16.0599 6.69424 -7030 4 4.7967 18.411 19.709 2.93149 -9.05217 4.33299 -7031 4 4.77097 17.8526 21.1546 15.0176 4.61027 -13.5236 -7032 6 24.7236 34.9657 30.1688 -3.59195 -26.0802 -14.261 -7033 4 24.7803 35.9013 30.0428 5.00342 21.1487 3.94382 -7034 4 24.6904 34.5809 29.2706 1.13339 13.2018 12.9935 -7035 6 31.868 4.6188 18.1813 26.0749 -11.7783 -2.21043 -7036 4 31.7807 5.26575 18.8694 -2.85928 14.415 8.06415 -7037 4 31.0011 4.54965 17.8036 -17.7428 -0.954819 -5.29079 -7038 6 8.70915 17.4782 5.92977 -5.10088 36.478 0.166614 -7039 4 7.99285 18.1665 5.8727 10.0003 -20.7449 -0.10219 -7040 4 9.53277 18.014 5.87919 -8.17468 -12.6369 7.06335 -7041 6 29.8448 10.9674 14.467 -9.24737 10.8237 6.24964 -7042 4 29.3518 11.4625 13.8111 -3.5417 -3.22768 -11.9456 -7043 4 29.8741 11.602 15.1948 7.6561 -6.41884 12.5924 -7044 6 48.7193 10.2987 32.5837 48.7914 -16.5053 -5.27468 -7045 4 48.664 9.84191 33.449 -1.5926 15.0761 -9.20872 -7046 4 49.6917 10.1556 32.2801 -49.2626 10.4163 8.33251 -7047 6 8.33128 15.6672 37.865 4.36755 4.12409 -33.9682 -7048 4 8.08142 16.0688 38.661 -6.22033 14.9054 48.1983 -7049 4 7.78443 16.1766 37.2488 7.82296 -4.92397 -7.06368 -7050 6 50.3849 3.07587 17.3306 53.0616 0.797084 -5.54454 -7051 4 49.9901 2.96071 16.4818 -23.7547 4.5323 -14.3202 -7052 4 49.831 3.21284 18.0832 -29.2444 4.71684 15.357 -7053 6 14.687 38.3962 10.9034 11.8452 2.26847 -28.7684 -7054 4 14.4993 38.5723 11.8231 -13.1425 0.700252 11.382 -7055 4 14.2628 37.5785 10.602 -2.45756 1.24341 13.1034 -7056 6 34.1174 6.37976 10.8168 12.9161 5.50138 13.5595 -7057 4 34.1292 7.23477 10.3416 2.23773 -14.4836 1.59416 -7058 4 34.9287 6.34152 11.3848 -14.7297 9.70771 -12.8953 -7059 6 7.1619 37.5492 17.6341 50.2032 -5.81562 0.15107 -7060 4 8.17599 37.5098 17.465 -47.7372 -0.307972 7.49553 -7061 4 7.05745 37.0565 18.4805 -8.53445 9.44148 -12.9936 -7062 6 51.515 11.3168 16.7982 -26.0757 5.86397 -27.0874 -7063 4 52.235 10.8459 17.1551 30.0977 -19.3818 20.7126 -7064 4 51.5008 11.0547 15.8562 -2.22905 10.0255 8.80825 -7065 6 15.6633 8.64974 3.19872 2.04011 -21.0584 -36.8111 -7066 4 15.359 9.2987 3.81038 -7.3063 19.0886 25.5551 -7067 4 16.1924 8.00887 3.67257 5.32849 -2.14206 7.59436 -7068 6 5.43671 21.4488 11.9213 -35.1135 30.2715 2.68526 -7069 4 5.1197 22.3031 11.5306 26.1226 -15.3225 -1.30607 -7070 4 4.71321 21.2794 12.5494 12.8867 -7.97314 3.40019 -7071 6 50.1888 24.041 37.9733 -16.5158 11.6838 -8.72192 -7072 4 49.5513 24.2503 37.2525 13.6843 -9.6942 16.9361 -7073 4 50.7608 23.3204 37.7156 0.52347 -2.66969 -5.08066 -7074 6 39.7366 11.2383 31.6978 23.7892 31.0409 -10.9794 -7075 4 40.3477 11.919 31.322 -8.85632 -23.7146 9.45819 -7076 4 38.8907 11.643 31.516 -11.7678 -2.00245 1.00495 -7077 6 26.6862 10.831 20.5846 -4.64528 13.8134 22.6501 -7078 4 26.37 11.3609 21.3584 5.46785 -6.26709 -23.7021 -7079 4 26.5097 9.94471 20.9062 3.28762 -9.42115 -6.7075 -7080 6 12.5617 17.5693 18.1619 57.3415 -16.6047 -35.4946 -7081 4 12.3732 16.6356 17.927 -10.1847 12.7431 11.2408 -7082 4 11.9536 17.9401 18.7496 -47.3477 6.23269 31.2745 -7083 6 47.7779 31.603 17.3345 -16.0229 -2.6295 -18.0517 -7084 4 48.4774 31.3981 17.9449 0.342859 -12.7175 10.4199 -7085 4 47.3751 30.7658 17.0144 6.51745 15.1025 2.87388 -7086 6 1.06661 3.38166 18.5387 0.482315 1.39351 -20.5486 -7087 4 1.47214 3.81044 19.3024 -7.19452 2.23946 8.83247 -7088 4 0.121217 3.21323 18.6865 2.92702 6.89788 10.7589 -7089 6 26.5916 20.3882 15.3141 4.05487 -19.1164 -7.10575 -7090 4 27.0276 19.5492 15.0037 -7.93965 16.9744 10.3813 -7091 4 25.6772 20.1067 15.4922 9.40368 -0.641397 -3.80974 -7092 6 42.0092 3.03717 36.7607 9.58516 7.42569 -27.539 -7093 4 41.472 2.27114 36.5289 -4.68032 -10.5632 12.6255 -7094 4 41.9749 3.27199 37.6769 -10.2045 -8.66607 25.0137 -7095 6 39.3197 22.4482 33.2161 17.1359 -6.1719 -1.11969 -7096 4 39.6777 22.5385 34.1471 -14.6651 4.73191 -34.7467 -7097 4 39.2891 23.3308 32.7977 1.66572 -7.01471 12.3298 -7098 6 18.4983 34.959 11.9233 -52.4092 11.8234 -6.15541 -7099 4 19.3311 34.9297 12.2931 62.358 -5.27325 28.8625 -7100 4 17.9525 35.2018 12.6795 -15.7268 -2.39727 1.11957 -7101 6 22.849 14.1156 0.206953 9.43339 -22.8796 20.8561 -7102 4 23.1273 14.7687 41.4941 9.338 18.1693 -9.76493 -7103 4 23.4344 14.2183 0.991573 -8.36464 7.13735 -11.7533 -7104 6 31.0127 16.6435 33.7717 -75.3989 -12.3916 10.6429 -7105 4 30.4261 16.8588 33.0132 20.7291 0.745933 12.1228 -7106 4 31.8948 16.7604 33.5238 39.9201 13.7608 -15.1754 -7107 6 28.4056 35.5121 5.54765 -4.91817 12.0412 -0.933493 -7108 4 29.0647 34.8486 5.74161 15.0982 -5.96625 -1.02933 -7109 4 28.8561 36.3656 5.44297 -1.6946 -6.58589 1.12865 -7110 6 2.06022 31.4415 10.6404 20.6415 1.38777 10.2498 -7111 4 2.4899 32.1989 10.2195 -2.44284 -2.19106 -3.22737 -7112 4 1.13111 31.6267 10.6164 -17.6565 -0.143118 -7.1498 -7113 6 5.95467 9.75858 21.3545 2.17354 8.87983 -50.8842 -7114 4 6.2643 10.5435 20.7894 -11.3634 -34.5597 22.4005 -7115 4 5.48441 9.14719 20.7121 9.8282 23.6666 23.1144 -7116 6 24.7866 26.6177 2.6661 -24.4024 -28.5469 2.9707 -7117 4 23.9476 26.6963 2.18158 9.10826 11.4817 -7.6186 -7118 4 24.6214 25.7954 3.1805 15.5163 19.2379 2.11057 -7119 6 45.7515 4.24664 18.6084 -0.948574 6.19926 2.59566 -7120 4 46.4738 4.91595 18.5123 -9.05862 -19.7882 -0.326833 -7121 4 46.0843 3.34349 18.421 4.31178 15.089 3.21664 -7122 6 4.45878 0.783326 15.9106 20.8465 2.39674 -2.22601 -7123 4 4.33336 41.7534 15.8294 -11.1347 -14.3847 -2.31303 -7124 4 5.37758 0.813141 16.2285 -10.0444 13.1447 -0.149196 -7125 6 2.44065 19.4988 25.3899 -18.2163 -19.9205 28.2208 -7126 4 1.89428 18.9873 26.0273 4.60516 17.0002 -8.33323 -7127 4 2.55045 18.8717 24.6878 9.48029 -1.77855 -17.0048 -7128 6 40.6027 8.48954 5.10826 -27.6355 -21.4881 -13.6167 -7129 4 40.6592 9.31425 5.57088 10.9479 16.5697 14.8472 -7130 4 41.3781 7.96424 5.30637 14.4251 2.68711 -2.52113 -7131 6 49.3092 22.3481 41.5186 -9.93734 74.0457 16.0776 -7132 4 48.4971 22.7919 41.1786 21.3857 -10.289 -0.267672 -7133 4 49.2285 21.4633 41.2985 -4.59952 -62.95 -16.8011 -7134 6 0.364483 40.9333 20.5966 -24.8933 -11.8265 -30.66 -7135 4 0.190818 39.9667 20.5681 4.35782 8.08342 1.06674 -7136 4 54.6936 41.3396 19.9676 13.1862 -7.22974 19.6204 -7137 6 34.8864 15.3279 38.0452 -17.1782 37.3505 -55.2903 -7138 4 34.2682 16.0872 37.9321 5.94042 -16.3876 6.60377 -7139 4 35.3697 15.4116 37.1797 -1.56134 -6.74346 24.1748 -7140 6 7.76223 25.9987 29.8652 25.7268 -8.51605 -4.95409 -7141 4 8.61839 26.4638 29.9588 -13.1921 -1.71741 1.7916 -7142 4 8.05672 25.0651 29.9772 -19.4202 16.3818 3.54783 -7143 6 40.7182 22.7954 20.4441 37.8127 13.8011 -33.8007 -7144 4 41.3586 23.4588 20.0133 -28.9149 -26.2189 23.8294 -7145 4 40.2017 23.2969 21.0583 -10.7099 15.3396 13.8501 -7146 6 37.6932 25.6399 36.0638 4.62997 10.0285 35.1853 -7147 4 38.3287 24.9236 36.1183 -2.20273 -4.01008 -9.65359 -7148 4 37.2914 25.6394 35.2107 -7.09628 -5.12362 -31.4654 -7149 6 5.46101 24.0014 10.2586 17.9799 16.5872 6.22131 -7150 4 6.04134 23.844 9.49543 -11.5162 -2.35388 5.85767 -7151 4 5.90746 24.7967 10.672 -23.415 -30.7572 -16.8601 -7152 6 48.4104 21.0451 38.1819 10.5351 27.9197 -28.7006 -7153 4 48.793 20.7803 39.017 13.2175 -6.38321 0.209366 -7154 4 49.1228 21.3802 37.5459 -28.8109 -18.4864 30.6779 -7155 6 15.2906 25.011 3.54101 2.70625 6.69817 -9.95824 -7156 4 15.4569 24.0555 3.50682 -9.52162 -0.514188 6.9158 -7157 4 14.6826 25.2483 4.2581 -1.83637 -10.9582 1.3864 -7158 6 46.3949 40.2718 20.0841 3.05266 -42.5213 0.389481 -7159 4 46.7282 39.319 20.1688 -17.5494 37.8624 -2.40649 -7160 4 47.138 40.8016 20.3323 14.2597 18.5668 -0.122304 -7161 6 34.6662 36.4732 0.324161 -52.0076 35.1593 -1.38074 -7162 4 34.82 35.9689 1.09464 17.4812 -18.6855 30.1307 -7163 4 33.7817 36.8781 0.601954 33.7085 -7.09846 -24.72 -7164 6 52.5968 8.00424 30.4116 -30.791 -5.83914 -1.44892 -7165 4 52.0396 8.66036 30.8559 12.8564 7.40177 -0.477247 -7166 4 51.9287 7.58179 29.8369 22.2614 -6.63703 0.63559 -7167 6 32.0772 3.86049 29.4688 -16.0025 -7.01815 -35.05 -7168 4 31.5382 3.03776 29.5615 20.8838 14.671 -1.22835 -7169 4 32.0904 4.03293 28.4798 -1.86833 -11.5506 40.3284 -7170 6 20.363 17.8245 28.646 3.47804 13.7512 -7.92665 -7171 4 19.5516 17.4966 29.0653 6.53113 9.74715 -6.36853 -7172 4 20.0825 18.3002 27.8308 0.555567 -8.90179 15.8758 -7173 6 30.4041 41.1634 41.0132 -16.7253 12.0993 -9.83452 -7174 4 30.5197 40.835 40.1072 4.71307 -5.7925 7.34595 -7175 4 31.1703 40.9637 41.5368 18.7313 -7.07732 1.06037 -7176 6 35.4542 32.8539 27.9215 21.6406 26.5455 -21.3275 -7177 4 35.1435 33.2362 28.7432 -6.21594 5.85967 7.97646 -7178 4 35.8745 33.6007 27.3754 -13.2283 -32.0923 16.9769 -7179 6 14.39 6.67952 12.731 -12.5058 36.491 0.424373 -7180 4 15.2321 6.28981 12.9462 8.74388 -6.1299 -2.75421 -7181 4 14.5067 7.66796 12.7988 -3.69921 -34.1177 -6.56265 -7182 6 41.8739 41.5433 20.319 24.4238 12.2951 6.29746 -7183 4 42.7192 41.2715 19.9184 -11.0628 6.38436 -6.30872 -7184 4 41.3184 40.7767 20.2955 -10.4459 -12.1473 -5.48062 -7185 6 46.3985 22.5739 8.8638 6.84921 19.3184 1.79378 -7186 4 45.8729 21.8991 8.42669 -3.07803 -12.5032 3.12866 -7187 4 47.1271 22.1566 9.33065 -8.50589 -8.34396 1.5145 -7188 6 17.4023 20.6526 13.9004 10.6995 28.5611 -11.4854 -7189 4 17.6978 21.6036 13.9579 -8.84666 -31.3302 7.07381 -7190 4 17.3123 20.5004 12.9448 0.490636 -3.23538 4.08121 -7191 6 8.20126 9.48382 13.3485 -42.4293 41.8522 17.2798 -7192 4 7.44487 10.0964 13.6076 19.5538 -29.8853 -13.4391 -7193 4 8.9576 10.0119 13.6277 13.7224 -9.45646 -1.54211 -7194 6 7.58554 14.8008 29.5824 -2.61798 9.90858 -2.64866 -7195 4 7.05733 14.3538 30.2458 -0.514214 1.68252 7.63674 -7196 4 7.01989 15.5029 29.2149 4.91731 -6.06465 -0.976267 -7197 6 29.5668 39.2268 22.6285 -3.66094 -2.39634 13.3419 -7198 4 29.8353 38.7557 23.4169 -4.20308 -7.76017 12.2752 -7199 4 30.3745 39.2765 22.1369 12.5997 4.36069 -18.8462 -7200 6 19.725 28.7952 8.44488 15.8543 2.58223 -4.45186 -7201 4 19.5131 27.8757 8.63421 -2.81313 1.38303 -4.16069 -7202 4 20.6983 28.808 8.54393 -13.7447 6.84799 3.59225 -7203 6 20.0995 21.6275 25.9249 -17.5249 50.4223 5.09745 -7204 4 20.7082 22.0204 26.5908 -8.84326 -18.264 -10.6066 -7205 4 19.3931 22.3347 25.9239 13.215 -30.9895 -3.48111 -7206 6 12.7711 16.1006 22.7986 17.0661 -2.75106 -3.7002 -7207 4 12.1316 16.7784 22.5952 -11.3059 6.43976 -4.8982 -7208 4 12.4647 15.3033 22.3372 -2.13756 9.04884 6.71194 -7209 6 7.09175 27.2069 17.991 -23.617 26.2366 -1.29155 -7210 4 7.8076 26.6007 17.9383 20.2011 -26.8554 -5.74897 -7211 4 7.19403 27.792 17.2318 3.33647 -0.0238245 -0.788587 -7212 6 32.3975 8.68618 34.8629 3.54321 22.8272 16.3539 -7213 4 32.7738 9.06402 35.707 -18.9002 -9.48773 -27.5474 -7214 4 31.4989 9.0701 34.6771 23.7457 -9.58556 9.46102 -7215 6 50.3515 28.2186 17.5351 -6.87553 0.519429 12.9107 -7216 4 50.2481 27.3572 17.999 6.5408 9.8464 -12.2276 -7217 4 51.0722 28.1417 16.8919 -2.26653 -7.3618 -1.59066 -7218 6 15.6741 32.1546 25.7968 -26.4348 -11.0143 -14.9159 -7219 4 16.4004 32.6083 26.1805 24.7846 13.6092 10.6573 -7220 4 15.1411 32.8481 25.3674 4.92309 -4.07512 11.5217 -7221 6 41.2877 22.001 29.6411 43.1174 -21.5596 15.2505 -7222 4 40.6305 22.5901 29.3541 -33.8214 23.827 -16.0773 -7223 4 40.8662 21.2212 29.998 -7.36398 -2.60921 4.02408 -7224 6 24.5416 12.7608 8.88206 5.17198 -11.9982 -20.3907 -7225 4 24.1774 13.5122 9.35398 1.69504 4.6425 -2.53241 -7226 4 24.2888 12.8675 7.94212 1.28664 -3.68024 15.0016 -7227 6 47.3025 20.1085 10.3977 1.21439 24.4816 37.2747 -7228 4 48.204 20.4596 10.4656 -0.7364 -8.12719 -10.3932 -7229 4 47.15 19.5905 9.61989 6.68365 -16.152 -23.0167 -7230 6 17.6916 14.2112 29.9613 0.736848 4.98565 -22.9932 -7231 4 16.8377 14.622 30.0672 -16.7241 9.37988 10.4211 -7232 4 18.1183 14.7557 29.2835 1.70081 -6.05446 6.16757 -7233 6 21.3481 34.5805 28.5342 -9.54463 9.82799 -20.865 -7234 4 21.5933 35.4178 28.0943 -1.05427 -4.62886 14.5387 -7235 4 21.7361 34.566 29.3968 13.4346 0.0141216 16.9261 -7236 6 35.1024 4.03924 4.01172 -45.5158 42.5484 12.3245 -7237 4 34.1858 3.89939 4.38295 32.1954 -12.7538 -7.33111 -7238 4 35.1016 5.02916 3.89259 9.91862 -26.8751 2.91657 -7239 6 29.9059 8.58368 22.6013 -13.5917 -22.6535 -48.6732 -7240 4 29.4773 8.30259 21.7189 15.3855 19.7125 42.6195 -7241 4 30.4378 7.8025 22.8052 -0.87874 9.41284 8.39762 -7242 6 9.78314 32.9658 15.9197 34.9354 -36.2496 39.6827 -7243 4 9.8463 32.0623 16.3137 -14.5131 14.3099 -26.4053 -7244 4 10.4229 33.3707 16.5321 -2.5459 17.7355 -14.0184 -7245 6 24.9212 14.2335 32.582 19.5351 -17.8621 25.1352 -7246 4 25.485 14.4356 33.3711 -14.9506 -0.509299 -20.0473 -7247 4 24.5508 15.0526 32.2925 -5.32053 16.7872 -6.18619 -7248 6 49.6539 21.965 26.2345 44.0267 25.2751 -8.97422 -7249 4 50.4399 21.435 26.5572 -22.3889 20.3635 -4.11669 -7250 4 50.0214 22.8598 25.9362 -18.5294 -37.2714 15.3372 -7251 6 39.2165 29.6282 28.7804 -1.72389 1.82743 -9.11301 -7252 4 39.3036 29.0201 29.5259 1.24025 -1.09654 1.55877 -7253 4 39.538 29.1266 28.0158 0.286751 -1.49672 5.82908 -7254 6 50.6899 34.7862 39.7499 25.3157 10.1005 12.0928 -7255 4 51.6472 34.6743 39.5192 -19.7186 -4.86584 -0.193213 -7256 4 50.1651 34.2508 39.1591 2.72681 -14.2758 -14.8682 -7257 6 29.2004 20.8742 19.5261 27.9811 -3.68804 20.7377 -7258 4 30.1466 21.1247 19.5553 -9.39276 -2.96688 2.79863 -7259 4 28.9246 21.1497 18.6738 -22.5466 15.5983 -24.0329 -7260 6 45.8438 1.42491 21.3861 -37.1737 6.40486 -10.0566 -7261 4 44.9885 1.11968 21.7285 6.97513 -0.0444158 -7.72874 -7262 4 46.4438 0.92117 21.8904 34.782 -15.8409 16.3481 -7263 6 26.1011 5.84859 12.9885 -16.9285 4.46913 -7.38549 -7264 4 26.5547 5.08441 12.6375 7.71787 -14.9735 6.0022 -7265 4 25.1614 5.66972 12.8036 4.71997 0.43883 -1.19571 -7266 6 9.00669 19.0403 23.7238 12.8928 30.373 -14.6892 -7267 4 8.06593 18.9071 23.7945 -12.9763 -5.98489 5.20443 -7268 4 9.0473 19.9093 23.2431 5.0983 -22.172 6.64837 -7269 6 47.6961 14.1782 40.0269 19.0377 9.97795 -11.4729 -7270 4 48.5222 14.3512 39.5239 -16.7083 -4.37767 10.6105 -7271 4 47.3795 15.0553 40.2888 -5.04524 -6.44815 -3.81417 -7272 6 47.9985 19.7874 0.500962 -66.9165 -27.0064 -39.4066 -7273 4 48.5513 19.9496 1.22397 26.1904 -2.55385 45.3318 -7274 4 47.2789 19.103 0.704655 34.6798 29.0788 0.973802 -7275 6 27.1606 39.6013 31.4318 -10.4761 -55.491 -38.6851 -7276 4 26.8926 40.2811 32.0159 -13.7359 20.3686 20.1783 -7277 4 26.3709 38.9998 31.2101 25.3937 25.349 18.055 -7278 6 20.7209 15.2822 27.3078 -0.805435 -7.71632 -8.78017 -7279 4 19.7876 15.3781 27.0487 8.25469 13.9731 2.34115 -7280 4 21.2532 16.0335 26.9925 -16.2498 2.55153 -4.46604 -7281 6 53.2722 3.12643 19.6849 41.3384 49.6686 7.26214 -7282 4 52.533 3.74254 19.7043 -8.02663 -2.92583 -3.0848 -7283 4 53.0086 2.23956 19.6703 -22.4403 -46.3419 -2.11618 -7284 6 40.7531 33.3786 24.0219 13.5521 -1.60379 23.9632 -7285 4 41.5067 33.1664 24.6167 -8.75803 3.71621 -14.936 -7286 4 40.1104 32.6626 24.1628 3.50492 2.6284 -2.95087 -7287 6 50.2066 37.8896 21.3771 44.4561 61.7722 -19.2089 -7288 4 50.9779 37.3435 21.496 14.3962 -14.5259 7.12428 -7289 4 49.4598 37.4098 21.5582 -59.0635 -51.549 13.7135 -7290 6 41.3233 2.3412 21.9924 -16.3503 12.7858 19.6024 -7291 4 41.3426 2.52207 21.0679 5.97541 2.4567 -21.4637 -7292 4 40.4663 2.75609 22.2585 17.532 -18.0725 0.252127 -7293 6 3.68867 21.2779 14.3383 -14.5707 42.5 -35.9941 -7294 4 4.12477 21.855 14.9587 9.56216 12.6885 8.47194 -7295 4 3.77328 20.4352 14.6935 9.76412 -50.205 23.6517 -7296 6 34.2782 11.1533 36.6146 -6.03132 -23.9347 13.7336 -7297 4 33.9924 10.5436 37.3334 13.9996 -4.78487 -21.5854 -7298 4 34.1172 11.978 37.0322 -7.62349 27.2634 9.28858 -7299 6 24.0533 21.9225 23.4615 4.73517 -5.47775 13.1649 -7300 4 23.9978 21.53 22.5886 6.00444 -6.53009 -8.74438 -7301 4 24.605 21.2935 23.9896 -10.4931 14.2472 -9.63662 -7302 6 18.8931 0.346665 4.41951 -1.70081 19.9518 7.76538 -7303 4 18.8368 41.3461 4.13842 4.04101 -8.25805 2.22226 -7304 4 19.3845 0.416823 5.25819 -4.2619 -8.11151 -12.0763 -7305 6 1.61167 7.82777 17.7295 14.4633 -7.55708 2.21629 -7306 4 1.68315 6.88308 17.5181 0.421421 7.02752 -3.81945 -7307 4 0.776664 7.94842 18.1735 -9.56642 1.01884 2.20602 -7308 6 9.88587 31.542 26.4865 27.4574 -58.0414 -32.6279 -7309 4 9.74723 30.8294 25.7579 9.18818 32.443 34.13 -7310 4 9.16596 32.1271 26.4328 -35.6644 31.0992 -1.66616 -7311 6 46.989 33.006 20.3636 -11.9681 -37.8677 44.1235 -7312 4 47.0707 32.5253 21.2626 7.56487 31.1056 -35.1941 -7313 4 46.435 32.3629 19.8924 4.61548 9.19147 -10.8851 -7314 6 49.5457 29.2916 21.3977 -38.7846 4.15079 -24.0209 -7315 4 50.3477 28.8236 21.2219 24.323 -7.55681 13.7085 -7316 4 49.5468 29.8542 22.1736 14.9668 -0.936193 10.2574 -7317 6 13.5153 31.8979 19.1528 13.8675 8.3184 29.6787 -7318 4 12.8458 31.9825 19.8587 16.0999 2.21739 -7.32054 -7319 4 14.3406 32.2634 19.5906 -25.0701 -6.26478 -24.6616 -7320 6 46.633 34.1066 16.9257 -0.036059 -36.1463 20.7227 -7321 4 46.8492 33.9929 15.9997 3.99258 8.43366 -10.882 -7322 4 46.9059 33.2223 17.3084 -4.9703 29.3867 -9.59361 -7323 6 19.7609 39.5392 2.42166 -7.20248 -0.896063 -14.0911 -7324 4 20.5606 40.0527 2.5788 -3.5749 4.99115 -1.28658 -7325 4 19.2738 40.0463 1.72337 11.6568 -15.7424 21.4794 -7326 6 16.5329 9.39795 28.3065 -12.6095 -8.72502 6.68605 -7327 4 16.4075 10.3536 28.3648 10.1088 3.80195 -3.74389 -7328 4 17.4502 9.20269 28.1082 11.2813 2.72217 -1.81406 -7329 6 3.0433 33.3643 8.96425 -4.92886 23.6682 -21.9772 -7330 4 2.41869 34.0757 8.74286 -2.57616 0.180013 17.6579 -7331 4 3.16376 33.0029 8.08154 7.55925 -16.3918 2.91827 -7332 6 49.6751 28.308 0.201579 -29.5359 7.30765 2.58258 -7333 4 50.5733 28.3754 41.8671 34.4717 0.327786 -9.88202 -7334 4 49.5726 27.4715 0.657175 -2.26504 -2.01296 8.34302 -7335 6 1.41619 6.84354 30.4994 -10.3235 0.0954103 3.42179 -7336 4 1.63397 7.74222 30.8225 4.19995 -13.4757 3.05915 -7337 4 0.761793 6.45905 31.124 14.5617 20.0187 -8.0296 -7338 6 19.7679 9.42131 33.717 -3.22882 -6.25654 -44.8315 -7339 4 19.9145 8.46604 33.7746 1.8774 1.59257 2.48781 -7340 4 19.5751 9.55831 32.7323 1.24521 6.76178 40.819 -7341 6 26.1724 11.919 3.61074 17.7641 10.7445 -19.8393 -7342 4 25.5356 12.1934 4.24073 -14.9718 14.8208 22.8097 -7343 4 26.0423 10.983 3.54915 1.55706 -20.7566 2.99847 -7344 6 33.2542 2.1444 18.2116 -1.15587 48.9982 3.93816 -7345 4 32.886 2.96086 18.6548 6.67205 -21.4839 -22.8104 -7346 4 32.6761 1.46025 18.493 -13.9253 -19.4899 6.26155 -7347 6 1.55797 29.1194 15.6221 -22.3111 36.2637 61.7506 -7348 4 0.853719 28.5449 15.936 -7.71843 6.28063 0.384394 -7349 4 1.90648 28.6788 14.9107 30.7784 -39.3832 -62.5327 -7350 6 41.7311 4.10421 39.5944 -40.7328 36.7616 -42.7174 -7351 4 41.3817 4.81242 38.923 27.6667 -38.3892 36.6931 -7352 4 40.9025 3.64602 39.8145 11.2401 -8.56921 5.26404 -7353 6 28.6823 41.7982 21.1955 47.2047 1.42594 -8.59686 -7354 4 29.177 0.720645 21.3267 -21.6507 -0.473723 0.486784 -7355 4 29.4617 41.2314 21.0003 -26.4876 -3.65191 3.02858 -7356 6 11.643 12.3982 35.4482 -35.2927 22.3423 -20.2863 -7357 4 11.5968 12.2307 36.3713 6.75035 -5.55932 30.2124 -7358 4 12.5522 12.401 35.2267 32.0712 -2.0845 -6.40416 -7359 6 9.80556 12.056 0.297197 42.0735 31.0338 -28.3715 -7360 4 10.6577 12.4693 0.65483 -33.0881 -22.384 -10.4034 -7361 4 9.20254 11.76 0.941289 -12.1624 -10.8407 36.4861 -7362 6 48.1632 12.393 9.2137 2.43833 7.21341 -5.5951 -7363 4 48.4522 11.811 8.50685 -9.57081 -7.25037 -8.94466 -7364 4 48.8896 12.3474 9.83523 7.41749 2.43397 12.8852 -7365 6 20.1331 24.378 18.9556 11.9182 2.36756 -38.9603 -7366 4 19.4372 23.8368 18.5171 17.2732 8.77886 9.60074 -7367 4 20.7988 24.6336 18.2364 -23.7637 -10.2166 26.3276 -7368 6 16.5494 31.2838 16.4573 -15.9423 3.69088 33.2062 -7369 4 16.5519 32.1922 16.7594 11.1434 16.9832 -11.781 -7370 4 16.1476 30.8867 17.2522 1.55385 -15.8871 -15.2552 -7371 6 1.78983 14.6435 36.2904 4.99553 5.58283 2.2492 -7372 4 1.04893 14.2282 35.8708 -13.8588 -3.35469 -16.6141 -7373 4 1.66905 14.392 37.2023 2.39459 2.07051 19.2387 -7374 6 4.37166 29.2153 29.5914 5.79168 20.1405 -19.3585 -7375 4 4.91557 28.7254 30.2154 7.17051 0.117226 5.39869 -7376 4 4.91513 29.9512 29.1891 -14.7291 -26.607 12.32 -7377 6 43.6969 0.237019 22.6594 -7.19613 -4.49497 -5.57098 -7378 4 43.0237 0.783547 22.2316 -12.2242 -6.81623 2.03469 -7379 4 43.4415 41.2053 22.5454 5.15142 14.113 -1.35906 -7380 6 52.5052 40.9917 27.2414 -4.0762 -16.2903 -30.037 -7381 4 52.8129 40.7577 26.3208 -10.5132 10.5144 20.9332 -7382 4 53.295 41.2999 27.6882 6.37269 9.42971 1.77711 -7383 6 25.5785 23.9088 27.7352 -29.163 -0.147769 2.09076 -7384 4 24.7169 24.3904 27.6009 26.0068 -16.0483 4.45096 -7385 4 26.303 24.4711 27.4736 4.98376 5.99744 -3.44082 -7386 6 23.1322 17.0409 33.3147 -4.87562 4.34963 6.5261 -7387 4 23.1435 17.5188 34.1474 -0.665908 -2.26574 -1.07751 -7388 4 22.9237 16.1327 33.5379 -5.85649 -9.89669 4.05086 -7389 6 2.9235 11.8719 21.3628 -62.5775 -31.8178 -28.2901 -7390 4 2.1985 11.2347 21.6738 31.4392 30.9604 -16.9464 -7391 4 3.51176 11.9111 22.066 35.7266 4.49799 37.8533 -7392 6 2.17958 4.14491 30.0321 9.06251 -9.53771 -13.2585 -7393 4 2.15165 5.09682 30.107 -1.56529 16.7016 0.150815 -7394 4 2.7299 3.97467 29.2422 -7.5281 0.377543 4.10315 -7395 6 26.6694 30.2855 13.4776 10.1196 11.7228 27.7054 -7396 4 25.7357 30.4785 13.6549 -0.51692 -11.2356 -3.98914 -7397 4 27.0778 30.3597 14.373 -6.55394 -4.70072 -25.9179 -7398 6 24.8731 30.8123 10.8246 -35.9544 -8.06722 -7.65859 -7399 4 25.2097 30.0125 10.4324 5.41746 -9.73411 -7.41209 -7400 4 25.6149 31.228 11.1936 31.2673 18.7081 18.3938 -7401 6 53.1638 24.1184 4.51161 -10.4445 -35.9395 21.0824 -7402 4 53.5233 24.7957 3.98549 14.2054 30.1141 -21.0763 -7403 4 53.9237 23.6117 4.81383 2.71167 2.31883 7.09562 -7404 6 24.8958 4.51213 23.9931 -29.6363 -43.6073 15.3227 -7405 4 24.1339 5.1036 23.9039 18.5944 16.8193 -2.99678 -7406 4 25.7258 4.88904 23.7461 22.8138 27.5954 -9.18982 -7407 6 34.6838 1.65591 41.2514 12.8053 -23.083 -29.6978 -7408 4 35.6244 1.45761 41.0729 -14.4971 0.421146 -0.177754 -7409 4 34.7301 1.99199 0.211928 -2.47028 17.9107 34.9925 -7410 6 13.312 19.5249 16.387 18.9594 -19.3284 17.3248 -7411 4 13.9333 19.1674 15.7225 -9.24732 -4.9188 0.52103 -7412 4 13.2597 18.8166 17.0929 -3.23838 18.5958 -24.3952 -7413 6 48.698 0.181353 20.409 -0.21633 -26.9433 -24.4133 -7414 4 49.103 41.5184 19.698 -4.34753 24.5911 30.5043 -7415 4 48.7986 41.623 21.2469 8.80211 1.41451 -0.511645 -7416 6 43.0644 27.7916 11.5133 -14.5871 -6.12813 -9.0892 -7417 4 42.6 28.0105 10.6776 10.2055 -1.97818 11.3293 -7418 4 43.4908 28.591 11.8257 3.55806 4.66568 -1.20709 -7419 6 25.6909 21.365 35.1834 16.6334 21.4278 -26.2382 -7420 4 25.8486 22.0441 34.4664 -6.54449 -15.4554 28.1071 -7421 4 25.5413 20.5536 34.6727 -4.24699 7.33591 15.2905 -7422 6 44.7232 4.60607 27.7619 9.66663 0.618053 -4.25407 -7423 4 44.3234 4.00717 27.1079 -6.11804 2.34462 0.765623 -7424 4 44.3971 5.50639 27.5932 -3.06611 -6.30885 -0.545657 -7425 6 41.2897 11.4432 34.2066 -9.61739 21.0206 -8.56292 -7426 4 40.6842 11.5664 33.4581 3.14959 1.41378 -1.0752 -7427 4 41.1924 10.5195 34.3892 0.589219 -23.8889 7.33677 -7428 6 19.897 36.6492 2.04794 -32.5825 5.5481 -21.6378 -7429 4 20.6399 36.2361 2.4987 10.0826 10.558 0.716761 -7430 4 19.9026 37.6342 1.97212 14.9366 -15.8518 15.2433 -7431 6 27.4836 4.66736 6.35028 2.97665 -65.4375 -50.0742 -7432 4 27.6123 3.82169 6.79207 -3.46759 -4.72632 -9.32934 -7433 4 27.4741 5.24116 7.04108 -4.39889 64.7262 58.0755 -7434 6 16.8382 30.7844 39.9326 10.6925 -56.0648 15.7324 -7435 4 17.0186 31.2572 40.7403 -2.33579 15.7179 12.0581 -7436 4 17.0831 29.8382 40.1617 -5.04661 27.4351 -11.6424 -7437 6 51.1641 15.1933 16.3324 21.7581 16.0625 -9.079 -7438 4 51.121 16.0888 15.8936 10.5188 -25.5533 9.6052 -7439 4 52.0677 14.7794 16.1385 -37.3149 17.1399 3.28502 -7440 6 49.9904 21.2241 35.9744 20.9503 -33.7397 19.542 -7441 4 49.3714 21.5088 35.3291 -23.4605 10.1211 -23.8745 -7442 4 49.9121 20.2362 36.0002 2.40052 26.2853 0.00810801 -7443 6 34.428 0.14016 5.66944 -7.82493 37.3161 8.31948 -7444 4 34.304 0.843366 6.34479 2.68801 -11.9822 -16.4886 -7445 4 34.2591 0.582485 4.80419 9.04141 -16.6905 11.7821 -7446 6 48.3182 11.536 19.8764 -48.9228 13.3726 26.2823 -7447 4 47.7285 11.3649 20.663 34.2262 -2.74449 -19.9886 -7448 4 47.7235 12.1441 19.3775 23.4884 -14.873 -2.11476 -7449 6 4.19152 39.4305 13.3555 27.463 28.0369 44.5079 -7450 4 4.88401 39.7456 14.019 -21.6239 -15.7277 -33.754 -7451 4 3.37287 39.6897 13.8148 -3.76347 -10.7833 -11.4512 -7452 6 8.74995 16.191 8.53596 -5.05856 2.64204 -21.058 -7453 4 8.7323 16.8633 9.22906 0.669847 -0.203387 -6.91741 -7454 4 8.69158 16.6347 7.64451 3.76071 -7.46014 24.9197 -7455 6 29.0285 14.2822 26.5262 -5.84817 34.0816 17.5192 -7456 4 29.0044 15.2824 26.745 3.30971 -49.1818 -9.92417 -7457 4 28.1563 13.9159 26.7584 2.39554 12.59 0.416474 -7458 6 27.3852 14.5292 8.14264 -25.3608 8.37865 0.80053 -7459 4 26.4121 14.3996 8.08331 21.4517 0.6706 1.76752 -7460 4 27.495 15.4908 8.29449 3.73212 -17.2528 -1.50339 -7461 6 14.1265 27.2071 32.922 33.1666 19.82 -10.1122 -7462 4 14.9257 27.349 33.4618 -9.56175 -2.66902 -6.75133 -7463 4 13.49 26.8422 33.5082 -21.5238 -13.7689 15.9353 -7464 6 31.6534 35.7886 21.2701 -36.804 -37.663 0.546332 -7465 4 32.1208 36.3742 21.8378 9.4961 28.0075 13.3964 -7466 4 30.8651 35.4592 21.7961 25.8489 11.2411 -16.1565 -7467 6 54.2152 28.7064 16.8886 2.86275 11.2554 8.9719 -7468 4 53.522 28.534 16.2345 -0.160695 -4.94794 5.34414 -7469 4 54.0581 29.6054 17.2296 -4.68599 -7.1814 -6.41975 -7470 6 9.06113 5.28333 17.1437 22.8853 4.22723 -20.1716 -7471 4 9.91678 5.17464 16.6036 -37.1561 0.754494 23.2593 -7472 4 8.77829 6.22091 17.0709 7.89423 -13.2605 2.73354 -7473 6 29.6746 9.78112 26.5507 33.4729 -21.3737 16.6755 -7474 4 30.5187 9.26436 26.5785 -19.9088 14.0899 -1.39861 -7475 4 29.3838 9.79264 27.4752 -2.64272 0.36338 -0.771294 -7476 6 44.0224 31.1718 32.1785 -15.3292 -7.28341 -3.2168 -7477 4 43.2245 30.9732 32.7283 18.2556 6.42044 -7.39667 -7478 4 44.6106 31.7763 32.6435 0.791193 1.46174 13.5451 -7479 6 53.5017 3.62335 25.1421 -16.9806 -9.67341 -1.19546 -7480 4 54.1073 4.37139 25.2408 5.33888 -0.871569 -8.36925 -7481 4 53.4976 3.25444 24.2353 14.6771 10.8199 10.1585 -7482 6 12.4523 22.8699 3.37515 20.8696 32.0548 51.3092 -7483 4 12.8715 22.0381 3.24611 3.69599 -28.8916 -15.1378 -7484 4 11.7545 23.0169 2.77653 -28.9409 -2.61743 -32.5554 -7485 6 39.4163 29.6883 0.716973 23.965 14.7498 -4.51132 -7486 4 39.9876 29.0776 0.254063 1.0023 1.05593 -7.22278 -7487 4 38.7356 29.138 1.03498 -27.9991 -12.2746 11.9106 -7488 6 13.7523 37.8126 23.0391 19.0421 33.8918 15.0049 -7489 4 14.5819 38.1972 23.3968 -5.92503 -31.5844 -9.82397 -7490 4 13.2717 38.649 23.0641 -23.8611 -10.9328 -14.9892 -7491 6 33.3489 41.2294 0.00543 12.0778 19.0207 4.12226 -7492 4 33.8966 0.076279 41.545 -17.8654 -16.3366 26.9287 -7493 4 33.5442 41.0956 0.968664 -4.79835 4.63337 -24.688 -7494 6 15.7246 3.52046 6.32841 10.9162 -8.85937 41.3038 -7495 4 14.9211 3.23468 6.78447 -0.787572 2.77727 3.3355 -7496 4 15.4617 3.69817 5.45032 -11.5336 7.63209 -33.5323 -7497 6 27.7759 30.762 5.08277 5.52432 -34.0682 -16.3389 -7498 4 28.5998 30.6312 5.57248 -10.7862 7.58152 2.34054 -7499 4 27.6688 29.856 4.68367 -5.5152 22.3618 6.77689 -7500 6 13.3283 7.58248 23.3427 28.3072 -1.43357 14.0598 -7501 4 14.1858 7.86415 22.9596 -10.8574 -4.57961 9.77565 -7502 4 12.7328 7.50745 22.6198 -18.1881 0.025746 -17.8687 -7503 6 38.3062 37.3234 27.9933 -3.63803 -3.21002 47.0561 -7504 4 38.1692 37.3862 27.0673 7.32148 -0.46048 -39.7323 -7505 4 39.0245 36.7163 28.2248 2.26391 -1.88339 -8.27891 -7506 6 35.8197 12.5511 12.093 -4.81482 -18.6185 14.0356 -7507 4 35.6024 11.6096 12.0486 2.81432 1.21601 -0.921604 -7508 4 36.2712 12.7262 11.2865 10.3444 9.98072 -18.0035 -7509 6 52.1161 23.0926 41.2793 27.7225 -3.87143 -59.8556 -7510 4 52.4049 23.0393 40.2964 5.44511 3.0042 51.4604 -7511 4 51.1968 22.9093 41.149 -26.7248 -2.75497 17.7375 -7512 6 39.5495 11.6692 16.6079 -1.17202 -14.5197 -14.1262 -7513 4 39.7784 10.7494 16.7482 7.99576 -7.98247 -12.1867 -7514 4 39.4663 11.9292 17.5115 -4.38422 20.0879 20.6825 -7515 6 0.676885 9.01905 7.96736 13.1741 22.7352 -22.4375 -7516 4 54.8016 8.92404 8.29683 -40.226 7.08621 2.19233 -7517 4 1.10058 8.31451 8.38908 28.7575 -30.4684 16.9583 -7518 6 42.3311 28.7401 39.4661 13.4879 80.877 11.2525 -7519 4 41.6603 28.5849 40.0851 -34.7426 -11.2721 27.5092 -7520 4 42.5519 27.921 39.1558 20.2132 -66.4303 -37.3003 -7521 6 38.7411 30.2829 16.2738 12.7671 5.32399 18.4704 -7522 4 38.9183 29.8748 17.1496 -6.87016 4.31697 -11.6029 -7523 4 39.4059 31.0046 16.2472 -14.9795 -12.5163 -3.03567 -7524 6 7.58764 18.0405 0.648325 -47.6574 -19.7672 20.3632 -7525 4 7.12731 17.6217 1.42737 12.1211 9.19751 -27.5752 -7526 4 8.47251 18.0259 0.938181 42.7013 4.4664 8.86021 -7527 6 33.7296 34.5938 24.1405 -3.484 -2.51034 -8.30179 -7528 4 33.5251 35.3309 23.5532 1.13599 -1.72579 4.26838 -7529 4 33.8994 34.9649 25.0137 6.47563 -1.63099 1.09862 -7530 6 16.0166 40.0494 39.5956 -28.3908 0.329345 -1.37751 -7531 4 16.9382 40.2323 39.4336 17.0381 0.329941 -6.23981 -7532 4 15.5262 40.0524 38.7513 12.3223 -0.591958 2.13513 -7533 6 4.49229 37.1333 21.8385 27.3085 -52.2253 -58.5501 -7534 4 4.66683 37.716 22.5264 18.8147 38.5231 40.56 -7535 4 5.37915 36.8768 21.3985 -41.7208 12.465 14.7942 -7536 6 39.2691 20.1288 31.3316 -12.2203 -9.20146 -18.9279 -7537 4 39.1503 20.9416 31.8094 1.95478 16.2675 16.373 -7538 4 38.6746 20.1785 30.5607 4.99665 9.53371 7.24081 -7539 6 28.5508 6.16368 32.0494 2.8072 -5.52183 -6.01527 -7540 4 29.3622 6.49582 32.4253 9.65206 -4.8896 7.96618 -7541 4 28.0782 6.98121 31.874 -4.3704 -0.58129 1.95425 -7542 6 9.33595 11.3298 38.1871 -32.8874 9.84086 11.8913 -7543 4 8.64445 12.0594 38.2922 21.8008 -26.7714 -10.0524 -7544 4 8.88851 10.5546 37.784 7.69784 20.5749 -6.72048 -7545 6 41.6095 10.4782 6.86111 8.23897 -6.62675 34.9169 -7546 4 41.7694 10.1037 7.78655 -4.1265 15.4661 -32.721 -7547 4 41.7821 11.4382 6.90291 -3.49967 -11.9299 -5.09907 -7548 6 3.12867 28.1157 17.6206 15.6267 -45.6796 29.9202 -7549 4 2.63816 28.6493 17.0564 -29.7899 29.6493 -43.0934 -7550 4 3.59757 28.7421 18.155 7.53462 9.15161 11.5693 -7551 6 39.3499 12.2397 19.2529 -23.7838 14.9837 13.9357 -7552 4 39.2457 13.2286 19.3464 7.91877 -27.4185 3.68816 -7553 4 38.6075 11.8387 19.7677 15.6586 5.94778 -12.3856 -7554 6 2.78491 9.11686 31.712 -26.5503 -22.4732 34.9375 -7555 4 3.2978 8.41451 32.2045 -9.27186 19.8876 -17.5091 -7556 4 3.27525 9.5282 31.0263 27.6548 6.40843 -16.0242 -7557 6 47.0993 34.3062 24.1668 40.213 25.5871 3.96938 -7558 4 47.8652 34.9011 23.9742 -8.40565 -28.0457 9.8184 -7559 4 46.4391 34.8642 23.795 -37.1496 -1.08965 -6.28687 -7560 6 41.29 35.6184 9.54316 -30.0867 29.8286 7.21591 -7561 4 40.3249 35.7138 9.72984 17.4159 -14.0538 -3.31523 -7562 4 41.5907 36.542 9.70742 6.71087 -21.892 -10.0971 -7563 6 20.4656 31.4513 3.14505 -29.4444 2.15246 21.5865 -7564 4 20.9799 31.2087 3.9226 8.79014 -0.482357 -2.15716 -7565 4 19.5517 31.5947 3.51954 23.5031 -1.57475 -20.844 -7566 6 33.2192 17.965 24.7971 19.8065 25.0952 18.1835 -7567 4 34.1598 18.0267 25.093 -16.2559 -11.4614 -7.96855 -7568 4 32.9244 18.9016 24.8301 -6.14071 -21.8705 -2.46334 -7569 6 40.1545 39.892 35.7566 -26.4952 1.03865 35.1005 -7570 4 39.554 39.7115 35.0283 3.12548 3.08468 -2.58895 -7571 4 39.5538 40.0617 36.55 23.7339 -1.54775 -30.4418 -7572 6 4.86493 34.7165 16.5037 -1.18866 4.83191 -8.79653 -7573 4 4.98021 35.6639 16.3239 -2.48039 -7.07182 -3.79473 -7574 4 5.57973 34.27 16.0245 9.17482 -2.77359 5.31354 -7575 6 19.1203 11.0308 26.5475 4.8369 12.9311 -1.38474 -7576 4 19.2948 10.8261 25.6303 -10.7878 -2.53157 -9.81197 -7577 4 19.6222 10.3806 27.0285 -0.932765 -12.0852 11.9627 -7578 6 54.013 13.9266 34.7866 19.735 -12.4153 18.0126 -7579 4 53.1377 14.0488 35.1524 -10.4928 -1.09871 -13.0068 -7580 4 53.982 14.1469 33.8595 -3.66316 10.2302 -11.2602 -7581 6 1.83695 20.649 5.20524 25.5491 14.9074 -17.0883 -7582 4 1.35705 19.8566 4.90021 2.5306 9.60758 -2.11708 -7583 4 2.48138 20.9466 4.48633 -27.5057 -15.388 16.1855 -7584 6 22.2484 0.089789 14.2543 15.3573 -11.1234 0.0573231 -7585 4 21.4821 0.622149 14.4313 -9.66168 8.29964 10.305 -7586 4 22.7606 41.8363 15.0657 -14.7435 5.42194 -5.09127 -7587 6 4.9437 7.03924 24.7311 13.2528 -2.19763 7.32506 -7588 4 4.13251 7.3412 24.2993 4.98795 -3.92941 -4.4547 -7589 4 5.31694 6.26419 24.274 -9.7854 5.58222 5.45409 -7590 6 41.4768 20.8727 34.9433 -10.8141 32.3245 17.6117 -7591 4 42.0721 20.1596 35.0936 18.2074 -21.2429 -2.25611 -7592 4 41.5511 21.3995 35.7803 -3.93981 -14.5735 -18.4651 -7593 6 28.2063 1.73787 31.7361 2.56856 -6.63991 -21.6427 -7594 4 27.5833 1.04583 32.0206 5.931 11.5306 2.70007 -7595 4 28.427 2.28487 32.4907 -6.15569 2.19681 12.1249 -7596 6 16.8959 27.3728 36.9936 3.36683 -9.46076 -21.7251 -7597 4 17.1861 28.0765 36.4018 -0.835984 6.87178 9.62195 -7598 4 17.1491 26.5677 36.4964 -8.72142 5.45523 11.8618 -7599 6 26.8172 38.095 8.33253 -7.04389 15.4319 43.7153 -7600 4 26.4231 38.1886 9.22965 13.1827 16.4204 -18.9623 -7601 4 26.752 37.1697 8.26194 2.82704 -45.8494 -18.5449 -7602 6 26.6605 33.8021 23.2109 -14.7721 -8.40788 6.86704 -7603 4 27.1437 33.2455 22.6071 1.71839 -3.83047 -13.3917 -7604 4 27.3181 34.0928 23.8234 13.6598 11.6313 12.8928 -7605 6 10.2089 27.1103 30.2249 26.5091 -20.839 -19.8889 -7606 4 10.2296 28.0525 30.305 -4.35446 23.414 7.17464 -7607 4 10.909 26.9135 29.5485 -17.3927 5.996 19.4297 -7608 6 47.8678 12.6068 5.01236 10.3402 17.2727 14.3835 -7609 4 48.2471 13.4466 5.34357 -15.5974 -13.1618 -9.91905 -7610 4 48.2827 11.9587 5.58273 0.760146 -12.24 2.37579 -7611 6 53.3401 24.5564 22.1447 -33.4845 3.13007 15.4457 -7612 4 53.2868 24.6175 23.1082 -8.50106 -5.88574 1.47389 -7613 4 54.2491 24.6404 21.954 37.9576 4.9603 -12.0283 -7614 6 29.4115 10.751 19.3682 47.3718 16.1602 -3.46693 -7615 4 29.23 9.95501 18.9095 -1.62259 -22.6341 -18.5903 -7616 4 28.6164 10.8767 19.816 -47.8248 15.8998 30.722 -7617 6 39.4772 14.9486 19.552 50.4126 11.9025 42.2912 -7618 4 40.3976 15.2789 19.8627 -47.7598 -21.1435 -8.50237 -7619 4 39.4723 15.2512 18.6704 -12.4406 15.8155 -35.6919 -7620 6 32.8813 15.9868 22.8125 3.47488 17.0872 -31.9433 -7621 4 33.0166 16.4922 23.6113 -1.39335 7.20309 14.6349 -7622 4 32.7144 15.0846 23.0256 -4.37432 -22.045 19.0968 -7623 6 30.558 1.96704 21.5074 2.70654 -4.91402 -0.473851 -7624 4 30.6739 2.00523 22.4671 5.88049 3.20632 -1.97238 -7625 4 31.3728 1.59666 21.1136 -11.8747 6.17773 7.16567 -7626 6 0.976021 12.0022 3.31788 -2.33791 2.9975 -11.3542 -7627 4 1.23381 12.945 3.27167 -8.13702 -10.1344 5.41434 -7628 4 1.05317 11.6593 4.21576 7.83216 6.74936 8.77967 -7629 6 32.1417 30.4028 20.7928 -10.9162 7.90477 -12.8705 -7630 4 32.9583 30.6218 20.3315 4.32484 3.35409 -0.814586 -7631 4 31.4267 30.7883 20.2371 10.7836 -11.8724 10.7529 -7632 6 5.37233 35.5196 8.9984 1.65786 -0.655334 17.0686 -7633 4 5.15633 35.7733 8.10502 -8.52999 -6.98357 -10.434 -7634 4 4.86772 34.7263 9.2434 -1.9757 2.02155 -6.9424 -7635 6 49.9125 13.0387 32.1973 27.4626 15.6741 -16.8517 -7636 4 50.6053 12.9182 31.4733 -26.2683 -0.306922 26.3637 -7637 4 49.2504 12.3613 32.0764 -3.75185 -11.6573 -0.304044 -7638 6 4.31386 24.093 1.57868 7.45772 -24.8618 -14.5348 -7639 4 3.64218 24.7342 1.7864 -13.9986 8.43803 -2.25361 -7640 4 4.01488 23.4668 0.872394 2.3276 24.3041 16.4513 -7641 6 44.1644 38.1215 12.3455 -22.0907 -25.3739 20.9172 -7642 4 43.5152 37.5597 12.8481 16.1408 4.83783 -17.5332 -7643 4 43.8688 38.9961 12.5721 5.21907 21.319 -3.3764 -7644 6 44.6817 17.3326 22.8013 48.0619 -4.56356 -9.07637 -7645 4 45.2902 18.0584 23.1498 -22.5072 -22.7727 -5.21409 -7646 4 45.2932 16.6008 22.4593 -20.015 30.0459 19.1644 -7647 6 20.3678 11.7042 19.6638 18.1083 -41.9451 -24.672 -7648 4 19.8947 12.3606 20.1264 -14.0753 36.8205 14.9866 -7649 4 20.5011 12.0109 18.7433 -0.799123 0.72776 10.7716 -7650 6 4.45477 15.3976 36.1886 1.65809 1.26145 11.9226 -7651 4 5.09661 14.6681 36.098 -4.75494 5.61497 -10.92 -7652 4 3.56051 15.0123 36.2095 4.93474 0.57137 -3.51241 -7653 6 44.8032 39.5214 30.1736 10.2403 3.65831 -28.7798 -7654 4 44.6649 39.352 29.2044 0.893291 -3.4354 28.9244 -7655 4 44.1834 39.0261 30.7164 -9.9549 -0.503639 -4.51595 -7656 6 30.0776 3.52093 11.3186 -8.111 -9.63673 -5.93937 -7657 4 30.5797 4.33725 11.0789 -10.9699 -19.7375 -4.73534 -7658 4 29.9808 2.85663 10.5812 14.022 21.906 10.2093 -7659 6 25.6241 24.8658 16.1333 6.68449 -9.57605 -29.1286 -7660 4 26.5694 24.8046 15.8818 -8.72523 1.1772 17.1704 -7661 4 25.5267 25.1318 17.0381 12.8553 5.85519 26.3055 -7662 6 36.8177 29.8487 20.6561 -37.5479 -3.0004 33.0202 -7663 4 35.926 30.1959 20.4157 18.2985 -1.907 -0.407745 -7664 4 36.6716 29.3784 21.5423 12.7247 15.2026 -39.3319 -7665 6 52.2186 17.0658 38.3042 -7.89215 -38.4825 28.5148 -7666 4 51.4916 16.4675 38.6484 24.7832 21.5941 -14.95 -7667 4 51.8247 17.6139 37.6469 -10.8917 8.73986 -12.7264 -7668 6 3.82879 23.6249 29.8747 0.0111461 24.9347 -0.194649 -7669 4 4.57266 23.2964 29.3507 7.82142 7.55197 5.89536 -7670 4 4.12107 24.4472 30.3626 -2.93665 -31.334 -6.69289 -7671 6 6.37221 19.8955 41.0814 -10.7405 10.6187 0.232117 -7672 4 6.67124 19.2607 41.7286 9.67887 -12.4754 3.81392 -7673 4 6.49825 20.7419 41.4991 -1.14685 10.1205 10.9238 -7674 6 28.9128 38.9237 35.3305 22.4394 21.6131 25.3888 -7675 4 28.4594 38.2476 34.8641 -13.9867 -26.2755 -20.0992 -7676 4 29.711 38.4973 35.7105 -10.7836 3.83713 -8.57645 -7677 6 1.06675 30.3059 34.4729 25.4378 -4.31804 35.0042 -7678 4 0.780778 29.8064 33.7399 -5.76855 -22.7951 -38.2413 -7679 4 0.490797 31.0506 34.5199 -18.1513 16.5028 -0.872558 -7680 6 26.4359 22.0299 20.4363 32.8101 13.5123 0.44111 -7681 4 27.364 22.3315 20.3938 -13.8894 -16.1779 0.0777322 -7682 4 25.9647 22.8561 20.3336 -19.4369 -2.2953 -2.32927 -7683 6 3.94837 18.6341 22.6823 32.7056 -17.0211 23.8668 -7684 4 4.7768 18.6814 23.2391 -24.3494 -8.73456 -16.7413 -7685 4 3.72444 19.5457 22.6416 -13.4357 33.3979 -9.86072 -7686 6 6.89585 39.3162 26.9832 -46.5714 7.68979 7.72716 -7687 4 6.93923 40.0377 27.612 28.7888 3.33438 12.9127 -7688 4 5.92214 39.2413 27.0287 16.4173 -5.75108 -11.0421 -7689 6 43.9872 41.7521 26.5322 17.8857 -12.0416 -16.5154 -7690 4 43.9509 0.2718 27.3768 -8.40653 9.77536 19.5266 -7691 4 43.1315 41.809 26.1188 -22.0408 9.50446 -3.00799 -7692 6 31.7113 29.5746 16.987 -20.6637 1.93471 5.13032 -7693 4 31.02 28.863 17.0135 12.5534 15.6398 -7.64726 -7694 4 31.2508 30.4156 17.2234 10.2038 -24.3383 2.42367 -7695 6 46.2561 10.9612 15.5385 0.577538 -38.7584 22.3134 -7696 4 45.3251 10.7213 15.4484 -5.02058 7.03855 -0.171485 -7697 4 46.6569 10.0824 15.7727 -2.20865 28.2857 -11.3723 -7698 6 36.5827 15.0435 25.8168 31.2067 4.61936 9.12499 -7699 4 37.3875 15.5118 26.1911 -33.209 -18.98 -14.6655 -7700 4 36.1295 14.6889 26.5897 -4.0863 -6.05063 3.58839 -7701 6 47.2722 22.6647 6.13576 -8.17133 27.0247 -35.749 -7702 4 46.6204 23.3224 5.77393 14.8224 -22.4366 13.8178 -7703 4 46.9842 22.4705 7.01441 -4.98592 -2.25738 16.061 -7704 6 27.5378 39.6651 17.8024 -2.94112 10.9701 -10.3343 -7705 4 26.5953 39.7232 17.618 -8.53785 1.10642 -8.0722 -7706 4 27.5664 39.1005 18.5557 5.38052 -12.9364 18.2146 -7707 6 14.0357 27.9675 36.8848 11.7171 -39.9071 2.25396 -7708 4 13.4367 27.1833 36.8225 11.7441 28.4062 -4.63591 -7709 4 14.9372 27.5486 36.8957 -17.1932 18.8386 1.76957 -7710 6 33.7684 13.0304 13.8649 26.1794 -24.2655 -33.187 -7711 4 34.6252 12.938 13.363 -28.3858 22.7045 20.1179 -7712 4 33.4338 12.1329 13.7478 -6.61414 4.24237 14.4002 -7713 6 3.3826 17.477 1.97134 -12.4208 -32.1468 -36.6933 -7714 4 2.99872 16.7111 1.40376 19.9781 39.313 29.0042 -7715 4 3.44044 18.2025 1.33186 0.336883 0.1642 8.16047 -7716 6 27.5407 2.76347 36.4361 37.1152 10.6125 -5.75272 -7717 4 28.1274 2.95293 35.6781 -8.18971 -2.06925 12.0999 -7718 4 26.7696 2.41682 36.0063 -15.232 -6.73967 7.66134 -7719 6 21.3092 1.20818 18.7198 27.6808 -56.7894 17.4302 -7720 4 20.9088 2.03925 18.6129 -17.8717 42.912 1.2548 -7721 4 21.1846 0.863131 19.6413 -10.5106 12.8119 -18.3621 -7722 6 11.8887 16.6751 29.3062 -13.3787 -14.7829 9.57092 -7723 4 10.9992 16.5416 28.8882 19.0949 3.10928 11.6713 -7724 4 11.8781 16.1991 30.1864 -3.15773 18.3703 -25.9576 -7725 6 15.9606 29.4505 29.6321 19.1231 40.0535 19.8704 -7726 4 16.8787 29.2659 29.409 -1.79459 -0.812108 -5.15406 -7727 4 16.0576 30.3074 30.1528 -10.887 -31.0851 -11.0284 -7728 6 42.9296 7.03459 4.51333 33.3286 4.63812 8.33203 -7729 4 43.4321 7.52085 3.82302 -14.3213 -8.56549 9.51251 -7730 4 43.6462 6.74019 5.1384 -26.8219 -5.28882 -15.1101 -7731 6 46.4281 26.3352 18.5118 -29.5226 20.9834 -10.3716 -7732 4 46.6343 27.1839 18.9751 -0.829481 -30.2492 -9.82569 -7733 4 45.6684 26.5824 17.9287 20.9241 -8.5113 7.46212 -7734 6 26.8394 31.9326 30.1088 25.5924 -16.6135 -32.4851 -7735 4 27.2107 31.0232 29.8435 -20.3392 35.4128 12.4615 -7736 4 26.6802 32.4017 29.2373 1.48159 -21.8349 29.7067 -7737 6 19.4878 37.6142 31.2562 -14.4543 3.58951 24.8148 -7738 4 19.156 36.8698 30.7235 -3.28844 3.66685 11.8368 -7739 4 19.1019 37.6358 32.1884 8.87174 -10.6544 -29.6345 -7740 6 52.3726 32.7139 12.8078 14.0751 37.5782 -32.6023 -7741 4 51.9367 33.0602 12.0031 -5.44932 -19.1877 9.81768 -7742 4 53.2329 33.1776 12.7347 -13.6236 -17.9256 14.0183 -7743 6 6.74161 9.28353 24.0307 -13.1667 -36.0519 9.75632 -7744 4 6.38029 9.61276 23.1997 0.718458 -3.76261 -6.90188 -7745 4 6.16941 8.51095 24.2946 11.6474 19.2019 -8.42102 -7746 6 39.7455 39.5612 25.4988 -8.346 1.54154 -0.59194 -7747 4 39.7035 38.6168 25.2826 0.975023 6.38379 0.651723 -7748 4 38.8484 39.7767 25.8082 2.0142 -6.85885 -0.770105 -7749 6 24.0762 14.0053 21.1456 13.3165 -18.5501 -35.6859 -7750 4 23.5798 13.5675 21.8237 -9.9014 -1.44375 19.5869 -7751 4 24.3047 13.2647 20.5221 -3.72657 29.1491 15.9401 -7752 6 5.19759 41.7876 24.8616 10.5329 -30.3401 13.9713 -7753 4 5.96107 0.070496 25.4117 5.01198 -1.48177 -8.04364 -7754 4 4.80364 0.70791 24.6471 -6.87058 19.426 -10.6286 -7755 6 42.3635 20.8692 21.2747 32.7502 -34.6644 -10.1673 -7756 4 42.4242 20.4785 22.1458 -3.583 2.66194 10.2144 -7757 4 41.7418 21.5604 21.318 -29.6652 28.4695 2.24145 -7758 6 48.2477 15.3659 33.5923 1.80889 -1.28345 12.5443 -7759 4 48.6164 14.6993 32.9992 0.330488 0.612282 -4.05403 -7760 4 47.6342 15.9182 33.1009 -4.13716 0.340872 -13.8372 -7761 6 46.021 38.2915 16.5867 23.3569 13.4435 24.034 -7762 4 46.6714 37.7063 17.0526 -15.1447 15.3639 -15.4724 -7763 4 46.2171 39.2064 16.9307 -10.1858 -20.2136 -16.2853 -7764 6 4.64649 28.484 21.3661 -49.4423 -36.8464 -34.122 -7765 4 5.0061 28.857 22.1388 17.5694 9.2675 37.6073 -7766 4 4.11403 27.6656 21.6036 24.8595 24.6655 -3.1651 -7767 6 20.5601 15.1658 18.389 17.6685 -18.4833 12.4376 -7768 4 20.0269 15.9148 18.1339 -10.4277 9.01273 0.992097 -7769 4 20.1375 14.696 19.1318 -1.87864 11.9594 -2.12399 -7770 6 16.2536 13.648 17.4664 -31.6255 -3.12789 -19.3987 -7771 4 16.1444 14.6075 17.6118 2.65347 -13.1818 -8.15029 -7772 4 15.6032 13.3943 16.7283 22.0135 11.6863 31.5082 -7773 6 52.4969 30.9511 18.1582 10.5176 -22.8935 27.2955 -7774 4 52.1187 31.5845 17.5724 -17.5669 13.4893 -21.7562 -7775 4 51.7599 30.5669 18.6706 14.518 10.6779 -8.97027 -7776 6 24.417 1.73185 15.7818 -6.46311 -4.24469 33.4298 -7777 4 24.2563 1.19981 16.5985 3.98325 2.24538 -18.7421 -7778 4 24.1038 2.61269 16.0335 4.13298 0.832539 -9.96215 -7779 6 23.8696 5.09384 31.0808 18.8621 -40.8234 -26.8653 -7780 4 23.8491 5.89936 31.5593 0.144588 30.2314 14.3891 -7781 4 24.8063 4.82715 30.9043 -17.3015 12.7186 6.18451 -7782 6 29.664 30.9246 0.393748 19.8337 -4.81556 23.0674 -7783 4 30.503 30.586 0.018652 -21.3617 6.75777 -1.54054 -7784 4 29.144 31.3327 41.6109 -5.17979 -0.628515 -14.2195 -7785 6 32.8496 37.8945 22.5158 10.0753 4.77658 10.1953 -7786 4 33.692 38.178 22.1563 2.67507 -3.41774 -7.7275 -7787 4 32.953 38.1222 23.4459 -10.6691 2.21895 5.00606 -7788 6 16.4801 17.3789 33.7607 -9.23434 -4.14589 -23.771 -7789 4 15.9446 17.8653 33.093 7.5539 3.01496 23.5583 -7790 4 17.136 16.9338 33.2029 1.0053 3.7812 3.66748 -7791 6 9.22576 13.3955 27.544 21.8484 -6.91303 -4.28818 -7792 4 8.36976 13.4851 27.1157 -15.2219 0.444174 10.4645 -7793 4 9.14931 12.9772 28.4181 -9.36318 7.36421 3.71477 -7794 6 43.4776 7.7356 17.2334 -9.59035 3.82748 19.1182 -7795 4 43.4092 7.74545 18.2218 0.501649 1.62452 -33.0026 -7796 4 44.4173 7.85634 17.0579 0.99974 -1.57098 -4.99047 -7797 6 22.314 24.3423 23.1668 -12.6246 5.51695 -1.93377 -7798 4 22.7955 23.5193 23.2443 6.83464 -10.1031 3.26418 -7799 4 21.5276 24.1384 22.6266 3.35813 5.31764 3.82921 -7800 6 26.0086 32.9187 32.7195 -0.756619 6.65713 -1.20686 -7801 4 26.2515 32.7095 31.8047 -0.82286 -4.52018 -0.557583 -7802 4 25.2078 32.4163 32.9092 -2.81033 -0.378904 -0.617388 -7803 6 16.9305 19.0463 7.44765 14.0068 18.7364 -6.96389 -7804 4 16.3855 19.2981 8.21028 -2.47769 1.30563 -6.88861 -7805 4 17.0815 19.8512 6.87677 -9.59141 -23.4241 18.196 -7806 6 48.1118 14.458 27.5672 -1.70385 5.14823 10.3583 -7807 4 48.0423 15.1786 26.9235 1.90686 -4.78611 -1.19899 -7808 4 48.0875 14.8765 28.4507 4.89589 -0.740891 -11.823 -7809 6 52.3863 41.7399 11.1185 2.41988 14.2085 23.7397 -7810 4 52.3863 0.193993 10.2459 -4.45976 10.8931 -22.0542 -7811 4 52.6887 0.557857 11.7005 -5.56281 -10.4239 -7.84704 -7812 6 36.3311 6.93589 12.7094 -2.38398 9.53491 -1.97617 -7813 4 36.3789 7.90344 12.827 -2.48918 -10.7733 3.15906 -7814 4 37.2588 6.6822 12.6726 5.22435 -7.00461 -0.877062 -7815 6 8.24215 20.3216 16.6719 4.98767 -5.10439 -5.65687 -7816 4 8.08588 19.3952 16.4038 -4.3079 5.82994 10.8424 -7817 4 9.2046 20.4438 16.7199 -1.30961 -3.63404 -4.19262 -7818 6 28.7954 40.3113 12.828 -13.6179 6.23593 21.4452 -7819 4 29.5192 40.3706 12.2287 20.8327 -7.3113 -16.8089 -7820 4 28.5554 39.3777 12.9053 -3.26344 4.60902 -2.65931 -7821 6 18.1473 11.8343 16.9395 -0.80483 -16.2761 12.6256 -7822 4 17.6848 12.6388 17.2294 4.62203 -2.59462 -3.9508 -7823 4 19.0947 11.9922 16.9221 7.13726 16.095 1.27241 -7824 6 30.8869 17.4142 21.504 -52.7305 12.2285 -31.3088 -7825 4 30.1482 16.8222 21.1884 27.1221 10.2955 22.0665 -7826 4 31.6253 16.8731 21.7262 19.9221 -18.6281 13.9623 -7827 6 34.8012 19.4194 37.9626 16.1869 22.0253 -15.6613 -7828 4 34.8979 20.1386 37.2822 -2.41662 -18.1877 20.3873 -7829 4 34.2105 18.7604 37.6043 -6.15487 -8.04615 -10.7113 -7830 6 35.8208 16.8923 29.2032 22.3367 20.7443 33.8648 -7831 4 36.613 16.5252 29.6466 -9.20578 0.119567 -6.22754 -7832 4 35.5382 16.2441 28.5922 -11.4717 -30.451 -21.7041 -7833 6 3.04279 32.2854 6.33929 -26.9238 12.3825 -4.69033 -7834 4 2.12647 32.146 6.0594 1.42689 6.59766 6.64942 -7835 4 3.42261 31.4611 6.08203 25.9982 -20.506 -0.598367 -7836 6 26.7966 41.6596 10.1464 32.6739 -10.8326 9.81865 -7837 4 27.6955 41.4226 9.79016 -25.5431 4.71255 4.81996 -7838 4 26.9918 0.01593 11.0584 -5.4334 2.64263 -3.14356 -7839 6 52.266 24.562 24.8685 -9.42886 0.421982 -6.72882 -7840 4 51.3046 24.7615 24.9057 17.7877 -5.82089 5.23086 -7841 4 52.6568 24.8699 25.6923 -4.67896 5.24225 9.60646 -7842 6 22.6938 22.6511 33.5751 -3.71591 7.58927 38.5179 -7843 4 23.2073 23.1628 34.2375 -1.81825 -3.74423 -24.5931 -7844 4 21.9227 22.4274 34.1227 -1.3969 -6.37714 -14.1968 -7845 6 10.6508 14.2453 33.0462 38.3111 -19.1724 1.31243 -7846 4 10.5904 14.9583 32.4175 -11.7628 10.624 -9.61146 -7847 4 9.79743 14.0525 33.3881 -28.4056 0.15536 2.16046 -7848 6 21.8963 10.8464 11.5207 26.0054 2.65771 10.2946 -7849 4 22.8204 10.615 11.7238 1.04479 5.32162 -7.74354 -7850 4 21.5123 10.8483 12.397 -14.7134 -4.5627 10.8449 -7851 6 38.3602 6.02493 25.8481 -1.65407 -6.16467 0.326828 -7852 4 38.011 6.16356 26.7557 4.19059 11.4538 -13.8011 -7853 4 38.4332 6.8537 25.3449 -2.0709 2.94932 12.5244 -7854 6 30.9335 26.6426 38.5759 12.2579 -6.52521 -50.146 -7855 4 30.9725 26.4832 39.4983 -1.12433 -12.3748 34.5417 -7856 4 31.1634 25.7976 38.1184 -10.2303 12.0451 18.6771 -7857 6 30.1758 14.6176 35.4883 -28.0954 45.5198 -22.6945 -7858 4 30.377 15.4621 34.9933 16.3957 -28.3235 8.82257 -7859 4 29.2055 14.6893 35.4544 11.1506 -16.8188 10.9927 -7860 6 12.5393 37.2199 16.9523 -39.8589 -5.36999 -7.27655 -7861 4 12.8749 37.9509 17.4338 22.3846 22.4284 20.6781 -7862 4 13.1653 36.5135 16.9845 23.2041 -13.3789 -0.375674 -7863 6 27.4265 21.5607 37.7225 20.8747 -12.9562 -0.181201 -7864 4 26.9326 21.725 36.9211 -12.0211 3.79264 -7.84561 -7865 4 27.0206 21.994 38.4656 -12.5008 8.35973 2.85409 -7866 6 29.6119 18.3909 12.6766 5.02953 -16.5769 27.1188 -7867 4 29.5217 18.1084 13.6179 -1.01954 6.11509 -19.9302 -7868 4 28.7057 18.4542 12.3734 -9.03627 4.70036 -1.08008 -7869 6 2.35849 15.6559 0.172343 -13.1317 26.5324 40.4931 -7870 4 1.57628 15.538 41.5798 -33.9312 2.46749 -10.4392 -7871 4 2.94928 15.1153 41.6306 46.9044 -35.3027 -23.6199 -7872 6 17.8239 25.728 4.21905 -37.6117 -8.49993 -31.7596 -7873 4 16.8718 25.6243 3.8952 33.4499 1.9374 22.526 -7874 4 18.2969 25.7387 3.3671 7.88894 5.9968 18.5236 -7875 6 41.8048 11.1855 20.2736 -2.74436 -4.31591 -6.39865 -7876 4 42.499 11.3266 19.6063 -2.31748 -7.213 6.47037 -7877 4 40.9812 11.3277 19.7997 -4.16553 7.78699 0.129723 -7878 6 38.0436 18.3822 24.0291 -8.03771 -8.75406 0.916934 -7879 4 38.3881 19.1147 24.5363 7.93091 8.32946 7.65245 -7880 4 37.8775 18.7197 23.1534 1.15748 3.59885 -9.88254 -7881 6 4.13949 13.9245 33.751 32.8429 -54.5446 -5.73928 -7882 4 3.27676 13.674 34.0388 -19.3763 3.63281 4.9893 -7883 4 4.61955 13.0097 33.6871 -20.752 50.0513 -2.76975 -7884 6 19.1955 19.1942 26.4999 -2.68794 -13.6734 16.0889 -7885 4 19.5301 20.0447 26.2113 2.49975 9.05121 -5.4902 -7886 4 18.8802 18.7176 25.7363 0.91839 -0.338605 -10.966 -7887 6 22.4654 26.212 25.3377 -43.9819 -31.3945 15.8492 -7888 4 22.341 25.462 24.7348 6.987 2.92742 -4.90062 -7889 4 23.2684 26.6111 25.1223 47.0594 15.091 -19.0516 -7890 6 48.8212 32.07 32.5598 -32.6217 13.0764 9.49579 -7891 4 48.8519 31.1339 32.3903 9.77015 -16.5586 -2.94571 -7892 4 49.6142 32.4858 32.2593 19.8009 3.1546 -7.06015 -7893 6 25.2092 18.0177 27.0119 4.84672 -18.7822 -3.15467 -7894 4 24.5216 17.4674 27.4199 2.41306 12.0417 3.55819 -7895 4 25.6695 17.4202 26.3966 -2.25094 9.61905 1.21472 -7896 6 1.75029 41.5558 24.9373 10.8929 -9.66126 -16.5331 -7897 4 1.94143 40.8029 24.3062 -11.1729 27.8661 22.017 -7898 4 1.33214 0.330238 24.3814 7.15774 -16.2959 10.6574 -7899 6 18.6827 11.7655 10.8523 -12.8723 -21.6642 16.1997 -7900 4 19.5636 11.9042 10.4948 -5.12175 -0.337419 -4.96303 -7901 4 18.6779 10.8452 11.2231 -2.76434 23.9208 -10.2934 -7902 6 45.6216 16.5622 4.85345 35.2391 7.72621 -8.96994 -7903 4 46.5826 16.2921 4.84248 -29.2944 1.01327 2.32041 -7904 4 45.6571 17.5026 4.56372 -8.00263 -16.2723 6.75488 -7905 6 40.6693 36.3938 24.0175 15.8353 8.34465 -33.37 -7906 4 40.8833 36.7626 23.1096 -14.2319 -6.57786 31.0793 -7907 4 40.765 35.4388 23.9669 -2.25062 -4.28397 3.06966 -7908 6 32.2103 36.323 4.961 11.3673 -15.0032 -27.5021 -7909 4 31.6022 36.0041 4.27996 -13.8963 14.3234 5.17466 -7910 4 32.9864 35.7931 4.73143 4.05858 7.46319 17.1387 -7911 6 1.60869 14.6755 10.8061 -10.0389 6.06769 39.8197 -7912 4 2.33356 15.3221 10.9109 -7.21973 -7.23845 -0.707439 -7913 4 1.19104 14.6475 11.7231 10.7485 2.93157 -30.114 -7914 6 35.0001 14.2727 28.079 63.2852 10.3217 34.449 -7915 4 34.8812 14.1453 29.0533 -4.19424 -2.10072 -23.3494 -7916 4 34.1798 14.2655 27.6589 -51.5469 -5.32036 -14.2309 -7917 6 54.7125 6.11605 21.8555 -14.0361 -8.25377 2.86163 -7918 4 53.7845 6.02557 22.1597 12.8111 1.82594 -4.22103 -7919 4 0.03027 6.89073 22.319 4.64766 10.0402 5.34703 -7920 6 31.7713 16.925 27.3783 -6.86907 -7.88471 17.2493 -7921 4 30.8352 17.1376 27.29 -7.38275 1.84485 -8.02972 -7922 4 32.1916 17.1776 26.567 8.49209 11.7792 -21.4891 -7923 6 14.465 28.0197 11.093 -4.59026 -39.5121 13.6529 -7924 4 14.1257 28.8224 11.4501 -8.46011 24.0779 0.0563038 -7925 4 14.7692 28.1802 10.1981 4.52198 5.50754 -5.24146 -7926 6 35.6475 19.4845 18.3155 9.57103 -1.809 -3.39748 -7927 4 36.1727 19.3545 19.1113 -4.74674 6.51425 2.74698 -7928 4 35.0476 18.7267 18.3208 -0.78661 10.9943 -3.1182 -7929 6 0.909574 12.7326 15.4512 -4.00403 -44.3255 -0.361194 -7930 4 0.713888 11.7498 15.2844 2.79491 38.2978 9.54583 -7931 4 1.42535 12.7402 16.2831 -6.10996 -1.10113 -5.97882 -7932 6 52.7151 14.8297 20.9852 -8.18072 -78.4028 12.8764 -7933 4 52.2089 13.9625 20.7908 19.9141 35.1606 18.4317 -7934 4 52.3599 15.4219 20.3591 -8.09633 28.1752 -16.3986 -7935 6 7.5074 6.79303 13.6094 20.1749 -33.1825 -2.20484 -7936 4 7.51894 7.72815 13.8132 13.5555 7.5777 -3.02343 -7937 4 8.44355 6.42469 13.5879 -32.5694 21.0012 0.325521 -7938 6 12.8707 29.146 30.9458 -23.5578 15.3335 -40.981 -7939 4 12.9428 28.445 30.3111 -4.06483 -0.044806 -18.3112 -7940 4 13.2276 28.7127 31.6654 25.7046 -17.9249 62.7325 -7941 6 8.91318 29.991 35.6703 -0.0610651 3.14803 31.5119 -7942 4 8.887 30.0597 36.6571 13.1627 -14.4278 -23.4692 -7943 4 8.81345 30.9051 35.4106 0.983205 7.41015 -17.1111 -7944 6 29.2436 7.20633 5.57892 -54.0378 33.243 -15.4453 -7945 4 29.9077 6.6209 5.82325 37.3203 -38.0996 12.3519 -7946 4 28.4255 6.92245 6.05186 24.5111 10.6259 -6.90283 -7947 6 25.8948 9.2579 3.86177 -16.7921 -19.1399 -16.9328 -7948 4 26.6486 8.78935 3.46547 3.6066 2.83982 9.7025 -7949 4 25.146 8.75694 3.47524 9.6908 8.1243 10.3781 -7950 6 46.1591 19.5353 23.8511 81.1089 -3.44953 5.31324 -7951 4 47.0572 19.4192 24.3423 -46.5837 0.334518 -9.80273 -7952 4 46.5432 19.8542 23.0066 -21.4105 0.836057 1.37554 -7953 6 18.5926 35.3225 28.784 52.2521 -24.0621 1.05868 -7954 4 18.6271 36.1437 28.292 -9.91963 10.3291 -8.20284 -7955 4 19.5499 34.9756 28.7398 -42.866 14.0686 4.10052 -7956 6 27.9863 22.6413 32.202 21.6529 -11.7193 -18.2399 -7957 4 28.0891 22.9783 31.3009 1.03266 3.02954 6.56078 -7958 4 27.1414 22.9613 32.5068 -4.28354 -0.549074 4.96673 -7959 6 25.9903 18.4326 22.6797 -22.9747 -15.6034 11.3844 -7960 4 26.7869 18.8273 22.3692 24.9379 13.7229 -5.91644 -7961 4 25.7208 18.921 23.4832 11.724 -6.94511 -8.75168 -7962 6 31.1697 23.092 29.1693 -11.9745 -15.1316 21.2053 -7963 4 31.2077 22.141 28.9533 -3.34012 7.58841 -3.35467 -7964 4 31.7416 23.575 28.5808 9.8436 3.86516 -11.5721 -7965 6 36.6303 4.93142 0.48008 48.3 12.3871 -22.3067 -7966 4 36.6637 5.82298 0.895967 -3.77214 -15.5899 -6.86281 -7967 4 37.4556 4.91994 41.7793 -42.6939 0.501904 23.801 -7968 6 36.4828 20.995 10.0445 1.4409 16.9025 7.88029 -7969 4 36.442 20.1354 9.60774 -3.67605 2.90774 1.0232 -7970 4 35.8889 20.9899 10.8082 0.675338 -5.55749 -3.21659 -7971 6 50.6068 25.1826 18.3885 -34.0155 8.99756 4.28297 -7972 4 49.9165 24.7513 17.8483 3.12051 4.84127 10.9758 -7973 4 51.4426 24.9479 18.0312 23.0155 -7.64449 -5.94589 -7974 6 50.1857 39.6546 12.4249 -35.8487 -4.75972 18.1961 -7975 4 49.7435 38.8097 12.6589 9.38526 12.3917 -5.89531 -7976 4 51.0761 39.4561 12.2056 25.3285 -5.23538 -8.69122 -7977 6 30.5392 12.4112 4.81308 -24.6918 -8.37115 23.8709 -7978 4 30.0105 11.5821 4.90198 12.5687 16.0288 7.14 -7979 4 30.9611 12.2897 3.99028 20.9425 -4.88336 -30.4106 -7980 6 28.9507 15.4785 21.8764 2.88494 -37.77 16.9414 -7981 4 29.2026 14.5932 22.3105 -13.0637 39.016 -13.1967 -7982 4 28.2142 15.8194 22.4189 7.40001 -5.36107 -10.8423 -7983 6 14.0621 9.56364 16.9937 6.86557 -12.9325 3.68967 -7984 4 14.7638 8.91135 17.1437 -0.397896 3.39204 -3.97785 -7985 4 14.5001 10.412 17.0773 -1.84745 7.98018 -3.95086 -7986 6 4.48418 30.1793 11.8502 16.4679 -16.8356 33.0547 -7987 4 4.88144 29.8061 12.6848 -7.18701 8.62616 -23.9784 -7988 4 3.54784 30.2411 12.0492 -7.30801 4.11375 -9.31782 -7989 6 40.8925 8.06286 23.6531 -5.33465 -0.617655 -7.49645 -7990 4 40.8929 8.28602 22.6923 5.67883 -10.477 13.1878 -7991 4 40.7177 7.10184 23.7416 4.86142 9.55736 -10.8624 -7992 6 53.7474 35.0502 16.7091 9.64852 13.8526 -34.5004 -7993 4 53.4511 35.8404 17.1588 -1.68768 2.98716 11.3576 -7994 4 54.0332 35.3898 15.821 -5.01984 -16.258 24.672 -7995 6 53.7089 10.1864 20.3635 2.29909 -3.91508 11.8946 -7996 4 53.865 9.95358 19.435 -6.30341 10.2468 0.803923 -7997 4 53.074 10.9174 20.4153 4.1525 1.61451 -13.3956 -7998 6 4.58325 27.0727 7.79253 38.2121 26.3993 -10.0836 -7999 4 5.27724 26.393 7.80253 -10.2172 -9.80276 1.23658 -8000 4 3.71677 26.7514 7.92113 -24.69 -25.9094 6.50141 -8001 6 50.5074 22.5408 22.1421 -8.69376 -16.3879 19.9073 -8002 4 50.2488 23.2402 22.7623 5.11604 2.17524 -13.9015 -8003 4 50.7961 22.8564 21.2903 3.5618 14.8025 -7.32432 -8004 6 7.04732 27.2027 21.6256 -40.8926 -21.8944 23.9514 -8005 4 6.7035 26.7027 22.422 28.3929 12.8045 -18.4773 -8006 4 6.19014 27.4064 21.2095 22.0893 5.82121 -6.88916 -8007 6 23.8331 35.0488 16.5891 16.32 14.4309 46.4508 -8008 4 24.6955 34.7392 16.9507 -15.4311 10.68 -10.0146 -8009 4 23.6772 34.608 15.7848 -0.180345 -20.5093 -35.2233 -8010 6 5.99568 23.9111 3.91414 -16.1284 -13.3557 2.33299 -8011 4 5.47632 24.0272 3.08057 3.14343 -7.41418 20.837 -8012 4 5.41258 23.5631 4.6401 5.53308 9.77645 -18.8553 -8013 6 38.7285 25.0725 19.1284 6.5843 12.292 11.4002 -8014 4 38.8305 24.3279 18.5317 -0.433768 -14.0645 -4.65001 -8015 4 38.9527 24.8378 20.0476 4.74577 -1.1864 -10.184 -8016 6 12.9754 18.2903 10.6176 0.588158 -4.74371 -11.7219 -8017 4 12.1189 18.2831 10.1754 -4.50324 1.27903 -1.36841 -8018 4 12.8026 18.5801 11.5112 2.24696 5.46905 14.7352 -8019 6 38.0467 41.2366 21.1082 -14.4892 -16.6352 -5.66336 -8020 4 37.1721 40.8226 21.1941 10.2151 -2.13153 3.70269 -8021 4 37.8745 0.133442 20.6393 0.730193 23.6843 -6.95691 -8022 6 6.9767 22.8602 17.8447 -15.6268 -18.8158 0.81989 -8023 4 7.5707 23.5707 17.6602 21.732 18.7089 -7.75629 -8024 4 7.31556 22.0497 17.428 2.05587 4.83625 4.35773 -8025 6 24.1095 19.3932 12.3316 12.1602 -2.11517 -13.1018 -8026 4 23.8745 19.734 13.1953 2.64822 12.0925 0.881714 -8027 4 23.8476 18.4865 12.3899 -10.6841 -23.2361 -5.46211 -8028 6 44.2232 28.4408 4.82746 -1.7669 2.66578 -25.5607 -8029 4 44.2803 28.1144 3.91045 1.22274 -3.80694 10.7546 -8030 4 44.1446 29.3994 4.68927 4.81937 -0.158515 8.55 -8031 6 23.3113 8.29915 21.4219 -9.51684 27.1403 7.66167 -8032 4 22.936 9.22921 21.4746 15.7805 -27.4461 5.90598 -8033 4 23.1012 8.0569 20.5135 3.89809 -6.65443 -0.402871 -8034 6 14.3464 2.18773 18.5362 -23.516 16.4481 4.67993 -8035 4 14.2678 1.24418 18.6898 10.1474 -10.2606 4.48578 -8036 4 15.2445 2.40605 18.3047 18.9771 -8.71598 -6.68368 -8037 6 28.0424 31.9381 34.1184 1.44373 -10.4149 10.0158 -8038 4 28.467 32.321 34.8914 3.92062 5.65333 3.09761 -8039 4 27.2701 32.5111 33.9835 5.51879 -6.95928 -12.9635 -8040 6 53.345 24.6925 18.2818 -10.4918 -25.9433 -31.7967 -8041 4 53.4866 24.6975 17.3285 -0.882305 -10.6531 -2.1422 -8042 4 53.7306 25.5021 18.5264 15.118 39.739 24.3772 -8043 6 36.8049 28.4285 22.9464 16.1639 5.31016 -1.79263 -8044 4 36.683 28.9472 23.7552 -13.3671 -7.69746 -0.238436 -8045 4 36.1639 27.7179 22.9267 -11.0056 -9.60672 10.1241 -8046 6 21.894 30.586 27.4834 -30.837 -7.47848 12.2714 -8047 4 22.1658 31.0121 28.3029 9.93408 7.2142 -4.82479 -8048 4 22.5499 30.6966 26.8178 23.3081 1.01511 -13.2982 -8049 6 10.2866 3.2829 27.2371 9.19947 -3.548 -7.92128 -8050 4 10.1566 2.73648 28.0281 -11.5907 7.20828 -5.58516 -8051 4 9.50383 3.79492 26.9844 -8.05462 -4.00143 11.7964 -8052 6 37.7145 25.01 29.7057 15.6828 -51.4836 -24.4954 -8053 4 38.34 24.5625 29.0621 -16.831 21.3675 19.2093 -8054 4 37.2613 24.2159 30.07 -2.41186 22.6264 5.87672 -8055 6 9.13271 24.4444 14.4751 26.0421 8.18538 46.692 -8056 4 9.10912 24.9781 13.7161 -5.31341 21.9098 -32.4591 -8057 4 8.68548 23.6494 14.2981 -19.3974 -37.2941 -14.6224 -8058 6 52.771 31.4727 7.38558 20.6973 -2.13415 1.08713 -8059 4 52.3061 32.183 6.93204 -2.34942 2.78723 -4.55897 -8060 4 52.1263 30.9997 7.89938 -16.8139 -9.70652 3.3966 -8061 6 21.3286 5.45224 36.4983 22.333 -40.4406 3.83692 -8062 4 20.7026 5.40277 37.2139 -7.55906 11.9598 8.05023 -8063 4 21.8475 4.61683 36.6516 -9.65069 29.8227 -15.0031 -8064 6 25.1743 37.2092 4.31919 7.23092 6.80805 -6.24923 -8065 4 25.4754 36.7175 3.5165 -8.68629 0.834167 19.7743 -8066 4 24.8491 36.6197 5.01948 2.53349 -5.19005 -7.77823 -8067 6 34.0165 17.4759 18.2358 -58.4306 -31.0723 45.6386 -8068 4 34.1944 16.9598 19.0779 8.50138 15.1756 -22.5601 -8069 4 33.0528 17.7413 18.4058 39.5305 3.9888 -12.396 -8070 6 37.9578 37.5059 25.2944 -35.6234 -15.4362 -10.7836 -8071 4 36.9622 37.6721 25.197 38.0574 -5.35834 -1.14338 -8072 4 38.1643 36.7565 24.689 -7.79603 13.8086 8.25116 -8073 6 5.07735 4.86484 15.8417 42.9381 3.72816 7.10952 -8074 4 5.88838 4.293 15.9163 -33.8081 0.492332 -6.16483 -8075 4 5.50277 5.71956 15.9997 -16.006 -0.473971 1.61617 -8076 6 14.1507 7.19336 7.76886 38.052 -10.4208 -22.4486 -8077 4 13.5129 7.55624 8.34295 -29.9694 15.266 25.1048 -8078 4 13.7195 6.96448 6.9333 -0.98027 3.69224 9.82406 -8079 6 24.98 10.8641 38.0829 22.9212 14.7137 56.6455 -8080 4 25.3157 11.7906 38.09 -5.76353 -21.6486 -14.5596 -8081 4 24.5861 10.6473 37.2742 -21.4949 -6.61803 -48.2716 -8082 6 35.683 7.97762 22.8121 -8.7657 -2.24292 -6.28447 -8083 4 36.2591 8.71308 23.0369 7.49089 3.45465 4.10549 -8084 4 35.4159 8.13228 21.894 -1.16553 2.61323 2.89561 -8085 6 24.8067 29.1485 22.4175 -2.13284 -11.1741 5.39142 -8086 4 24.8847 28.3567 22.9764 5.78872 7.02228 0.265808 -8087 4 23.868 29.1687 22.2304 -8.38579 3.51829 -7.32943 -8088 6 38.496 31.6463 38.4547 5.18571 -7.52333 -11.192 -8089 4 38.5561 32.3892 37.8222 0.442926 -5.96945 11.3455 -8090 4 38.4779 31.9675 39.3579 -6.04594 15.0172 8.52038 -8091 6 7.23911 33.2316 15.4021 21.919 9.41665 12.382 -8092 4 8.12833 33.2899 15.8377 -30.0201 5.59214 -9.80336 -8093 4 7.41373 32.5516 14.7298 -12.8129 5.82399 11.4308 -8094 6 43.353 23.6104 1.44592 7.44142 11.305 12.851 -8095 4 43.1845 24.4377 0.974361 -3.6145 -11.1369 -5.61195 -8096 4 44.1543 23.8467 1.95013 -11.1925 -12.9992 -13.6036 -8097 6 3.53991 32.9016 14.8697 -2.39625 2.76445 6.29056 -8098 4 3.69073 33.2429 13.9877 -3.53656 0.018747 -12.9915 -8099 4 3.78624 33.6349 15.4383 2.83762 5.11564 5.16825 -8100 6 25.3096 21.77 8.26163 -6.66296 0.990367 -4.9072 -8101 4 26.025 21.1206 8.24337 -4.14835 5.1806 10.2199 -8102 4 24.7855 21.68 9.08833 13.2195 -2.77387 -11.0894 -8103 6 43.8224 15.3683 17.7688 -17.5044 -13.9077 -11.4765 -8104 4 43.5422 15.0425 16.8907 -4.65964 7.2866 4.53357 -8105 4 44.7684 15.2434 17.7192 12.2011 1.97977 1.51727 -8106 6 15.7838 16.2525 16.6573 54.0838 12.7989 52.3812 -8107 4 16.4697 16.8261 16.2793 -6.54184 -0.771336 -3.5329 -8108 4 15.1467 16.1661 16.0105 -48.6612 -2.23154 -48.9531 -8109 6 31.9022 12.8519 11.5241 2.75902 49.2592 5.12049 -8110 4 32.4395 13.2725 12.2474 -7.6131 -20.2803 -12.0836 -8111 4 31.5562 13.6461 11.0457 0.0384164 -26.7823 6.27126 -8112 6 18.2248 5.33623 10.1812 -15.488 18.8418 -23.6702 -8113 4 17.7687 5.75894 9.42369 15.7694 -11.8332 4.62439 -8114 4 17.5271 5.29555 10.8288 -1.36455 -9.23689 12.3446 -8115 6 23.0917 39.0779 10.9282 -11.4905 7.21092 -0.352408 -8116 4 23.963 38.6888 10.8472 1.7552 7.95734 1.65941 -8117 4 23.1114 39.9529 10.5005 0.666922 -10.0515 1.633 -8118 6 46.8677 33.7562 8.76248 1.03354 -2.05441 8.38343 -8119 4 46.5037 34.5328 8.27588 2.5022 -8.853 20.9954 -8120 4 47.1475 33.9422 9.6931 -6.44786 13.1686 -22.3696 -8121 6 31.243 39.9317 20.2224 2.33635 -7.70313 -8.05101 -8122 4 30.8704 39.2996 19.5871 0.699046 7.37293 6.91414 -8123 4 32.2017 39.8574 20.0757 -3.27099 6.09826 0.0696837 -8124 6 15.889 33.0919 19.7864 33.8788 -7.40125 -13.3883 -8125 4 16.1628 33.8221 19.1895 -10.4151 -15.5823 0.760964 -8126 4 16.5176 32.3427 19.5839 -16.9866 18.4919 10.6578 -8127 6 32.5555 39.9164 2.66523 30.0039 -10.6491 -2.95451 -8128 4 33.3508 39.5896 3.12591 -10.8726 3.49711 -8.16538 -8129 4 32.1027 40.3655 3.36837 -16.5932 8.39248 6.84073 -8130 6 50.6959 12.1983 3.90519 17.0412 -18.9771 -24.2847 -8131 4 51.4658 12.4814 3.40053 -2.43524 -2.94964 -4.56419 -8132 4 50.632 12.8314 4.58319 -9.04718 30.5099 32.8795 -8133 6 44.7022 2.76366 12.1205 -8.84849 12.6495 8.41904 -8134 4 44.8494 1.8734 11.8267 15.0216 -15.1797 -4.64519 -8135 4 44.7278 2.73137 13.1008 3.87902 2.35132 -20.2006 -8136 6 11.5141 11.9335 31.6448 -3.41939 3.48047 19.9552 -8137 4 11.2577 12.7405 32.1375 2.53248 -5.05318 0.0588515 -8138 4 11.4496 11.2091 32.2982 6.40928 8.91696 -7.15415 -8139 6 4.75269 10.0418 10.4949 -1.19321 15.9867 3.21309 -8140 4 5.0001 10.2283 11.4058 3.15466 -0.54389 -0.234941 -8141 4 4.46559 10.9018 10.1184 3.18705 -14.0527 1.96128 -8142 6 17.0994 25.0099 20.58 37.5195 36.994 -31.4742 -8143 4 16.2483 24.8536 20.9144 -42.3557 -15.7488 8.6923 -8144 4 16.9647 25.6792 19.8535 4.26961 -24.361 15.5384 -8145 6 48.1092 4.75471 14.8037 19.9531 12.9172 -19.4869 -8146 4 47.21 5.0173 14.8371 -33.3483 -4.43172 15.4156 -8147 4 48.388 5.38041 14.11 12.4129 -13.382 8.75366 -8148 6 18.8523 3.11742 3.41631 -21.2483 -3.07087 -4.7476 -8149 4 18.4665 2.24821 3.59937 1.50537 0.955968 2.27262 -8150 4 19.7704 2.98892 3.60058 26.8928 -3.50499 2.30699 -8151 6 35.4247 26.4577 29.0527 -22.8013 -8.66021 5.68805 -8152 4 35.5248 27.2067 28.475 -2.85698 13.778 -9.76065 -8153 4 36.2768 26.0489 29.0602 21.3259 -10.4415 3.203 -8154 6 32.3896 31.2185 12.8503 57.1958 12.7231 -6.23232 -8155 4 31.5925 31.2509 13.3022 -48.7441 2.01486 27.8379 -8156 4 32.2029 30.8426 12.0127 -5.8383 -14.614 -31.3947 -8157 6 33.0076 28.3366 37.5983 -27.3824 -5.67666 30.0102 -8158 4 32.1052 27.9852 37.8568 28.4022 2.55731 -9.07316 -8159 4 33.3988 28.5694 38.4733 -3.969 -4.9759 -22.0899 -8160 6 45.5072 24.7908 10.3169 -45.8214 60.3209 -7.47747 -8161 4 44.9002 25.317 9.70444 28.5781 -13.9385 29.3176 -8162 4 45.5876 23.9971 9.85482 14.9117 -49.3191 -19.3714 -8163 6 14.779 31.7044 3.16918 -45.5594 -6.97168 29.5477 -8164 4 14.0337 32.2859 2.90387 21.9125 -3.3602 -3.07131 -8165 4 14.4311 31.26 3.996 20.2164 14.1486 -26.6391 -8166 6 31.9242 7.68885 4.30286 23.54 -20.9123 31.4536 -8167 4 31.4705 6.84633 4.17995 2.0164 -2.82895 4.59018 -8168 4 31.5931 8.24323 3.64247 -18.259 33.7262 -37.7068 -8169 6 42.5699 17.3136 32.1968 24.1944 7.3606 3.32713 -8170 4 41.6254 17.2329 32.2603 -19.9776 4.79877 -7.53323 -8171 4 42.7917 18.2007 31.8224 -10.4585 -19.5065 0.0265862 -8172 6 13.8071 23.1746 23.5515 16.4347 -15.6283 -2.15259 -8173 4 13.5183 23.7639 24.245 0.233797 9.11225 10.6616 -8174 4 14.6093 22.7029 23.9066 -20.7684 16.5326 -5.05411 -8175 6 10.7126 7.09833 3.97095 14.1471 -33.6721 -68.9477 -8176 4 10.4245 6.93934 4.82914 -14.4566 -0.97954 55.1879 -8177 4 10.4869 6.2311 3.50145 10.3151 35.4271 10.8748 -8178 6 28.7967 8.6797 17.9015 -30.1103 -2.72244 -33.0478 -8179 4 29.5795 8.35746 17.4579 9.90558 -6.78874 -8.85398 -8180 4 28.1705 8.90161 17.1378 19.1156 -3.64084 26.8114 -8181 6 19.4515 29.3423 26.6295 -39.4767 12.5835 42.7579 -8182 4 19.0038 29.6555 27.482 17.5864 -10.0531 -35.2193 -8183 4 20.2946 29.7741 26.6551 17.8114 4.03003 1.9258 -8184 6 40.6571 40.9865 14.5722 30.7749 0.116883 17.4953 -8185 4 40.9453 41.7159 14.038 -4.90719 13.3855 -18.4876 -8186 4 41.4974 40.7167 14.9881 -11.2006 -4.47055 2.16552 -8187 6 46.2595 14.0857 31.7293 11.6035 -9.35965 4.24636 -8188 4 46.4659 13.1386 31.6985 -1.25294 5.8657 1.71226 -8189 4 45.5092 14.1916 31.1613 -13.5258 4.10617 -10.238 -8190 6 36.7111 36.3198 8.38634 20.5175 24.5507 44.7988 -8191 4 36.5848 37.248 8.66174 -25.6048 -20.3538 -28.8485 -8192 4 37.4262 36.1922 9.03978 -4.76011 -28.7723 -18.9481 -8193 6 30.7791 32.4382 38.0814 8.60258 1.74334 21.9396 -8194 4 31.3949 31.9394 37.5795 9.21482 -20.9838 -26.5205 -8195 4 31.4122 32.9586 38.5821 -11.3785 16.1645 3.6603 -8196 6 47.8794 8.8384 10.1746 26.299 41.1069 27.7005 -8197 4 47.2075 9.11907 9.56312 -13.0744 -2.84885 -16.672 -8198 4 48.1152 7.93695 10.1106 -1.40956 -33.8723 -12.987 -8199 6 24.4191 17.0005 30.9872 -11.3759 2.04439 -13.9008 -8200 4 23.6647 16.9339 30.3566 16.9629 0.0568796 9.7226 -8201 4 24.0218 17.1528 31.8579 2.94571 -1.21426 -7.57694 -8202 6 40.5018 5.09847 4.47991 -26.6992 -20.3188 -5.14046 -8203 4 41.28 5.65048 4.47318 14.3705 11.228 -11.5737 -8204 4 40.0798 5.05838 3.58104 19.0568 4.03597 15.916 -8205 6 52.5742 28.0973 6.9077 -25.4379 -29.0344 16.6943 -8206 4 52.3933 28.6001 6.11132 1.2128 1.19853 -1.81518 -8207 4 51.7383 27.5823 7.10916 28.4347 22.908 -9.38917 -8208 6 36.064 32.3866 23.6124 7.53581 -25.1682 -6.10704 -8209 4 36.4508 32.2046 22.7426 1.48893 5.77393 9.47334 -8210 4 35.7934 33.2936 23.5958 -9.41601 17.7382 0.925908 -8211 6 23.6488 31.8764 22.7665 2.85736 4.06253 -9.33391 -8212 4 23.7634 32.5358 22.0878 -9.04528 15.3932 -0.43099 -8213 4 24.3599 31.3007 22.5126 8.23075 -21.5035 13.0322 -8214 6 0.735457 24.4657 41.7131 -9.37188 -1.3071 -20.2528 -8215 4 1.20497 24.8068 40.9273 -3.735 -3.01915 11.177 -8216 4 54.8235 24.2347 41.4089 15.688 5.53844 3.35783 -8217 6 15.9771 8.98022 19.8191 22.6241 -28.8974 20.594 -8218 4 15.5109 8.26292 19.4118 -7.13343 -10.7615 -13.7959 -8219 4 15.6388 9.77471 19.4696 -19.2292 39.8019 -15.8774 -8220 6 33.1716 12.5629 20.0326 13.9441 -12.6476 -4.49459 -8221 4 32.9044 11.6183 19.8429 16.5289 30.3248 6.35834 -8222 4 34.162 12.7185 19.975 -34.5589 -12.2038 -12.3621 -8223 6 7.03971 24.945 26.3683 -0.33354 -9.69316 23.9049 -8224 4 6.80945 24.3756 27.1101 -9.22275 -9.46444 -2.85995 -8225 4 7.84656 25.3251 26.6963 17.391 9.90995 -3.06061 -8226 6 44.4739 22.5508 36.9255 -16.7075 -6.88118 10.4755 -8227 4 43.5027 22.4108 36.9334 15.1456 1.07948 9.67769 -8228 4 44.6732 22.7799 36.0336 3.04889 5.98288 -21.3947 -8229 6 39.2775 23.7142 25.1185 -44.4168 -97.0378 5.9092 -8230 4 39.6033 24.5307 24.937 33.9242 88.3913 -14.6991 -8231 4 38.7559 23.4597 24.3323 8.03463 3.9453 13.1815 -8232 6 20.3756 2.20712 36.9897 -7.56257 -5.27652 1.95266 -8233 4 20.2168 1.45659 37.5665 4.06747 -3.41627 8.94019 -8234 4 20.2802 1.85339 36.1124 5.28277 1.38 -10.8685 -8235 6 22.8571 19.5527 3.6659 6.2145 7.79245 45.4341 -8236 4 22.8782 19.7834 4.64919 -10.5004 -5.13291 -37.3231 -8237 4 23.7426 19.8021 3.38476 9.02488 -3.84737 -6.15569 -8238 6 31.6989 12.5719 34.5929 20.3571 12.3337 69.8717 -8239 4 31.0774 13.2339 35.0297 17.9304 -15.3013 -22.977 -8240 4 32.3378 12.3324 35.3667 -30.4994 7.85147 -45.3393 -8241 6 12.9846 10.2214 25.1019 -30.6317 10.0697 -32.3453 -8242 4 13.6677 9.95937 25.6652 38.8731 -4.05338 37.0168 -8243 4 12.5116 9.4018 25.0264 -11.673 -9.01961 -8.06086 -8244 6 27.2702 0.587979 13.2088 -29.2359 -8.68669 8.17042 -8245 4 27.7024 41.6312 13.2942 -2.56798 3.03598 -7.56301 -8246 4 26.2795 0.464606 13.259 26.6373 -0.778522 -5.81594 -8247 6 5.6575 24.9337 13.9905 13.1991 2.90197 -9.87868 -8248 4 4.70598 24.9553 13.883 -5.9976 0.782062 8.57209 -8249 4 5.90972 25.4072 14.7914 -9.20077 -1.59682 1.38283 -8250 6 22.9799 17.9518 0.527007 -12.0607 -30.0717 13.8125 -8251 4 22.428 18.6392 0.176667 -3.67819 14.6501 -9.17369 -8252 4 22.2816 17.3415 0.914453 31.709 16.1034 -10.9012 -8253 6 33.0985 25.4181 5.46205 -15.7978 -31.0624 1.20161 -8254 4 33.3789 26.3039 5.55078 15.9502 30.9866 -6.27287 -8255 4 32.9645 25.2082 4.52957 3.04969 3.7853 3.27689 -8256 6 8.52872 7.94688 17.4833 18.4257 15.9711 -24.7978 -8257 4 9.39098 8.3855 17.3119 -11.8135 -8.35054 -2.98105 -8258 4 8.4858 7.94817 18.4262 -6.55829 -2.0729 23.5191 -8259 6 26.8237 0.686378 2.88748 4.07 30.2002 2.01549 -8260 4 26.8412 0.391628 3.80568 -3.86709 0.733005 8.35451 -8261 4 26.5975 1.66265 2.91719 8.86873 -29.5911 -1.41132 -8262 6 50.0397 34.7157 15.6267 -11.8175 -1.09292 -1.87233 -8263 4 50.6372 35.2521 15.0721 -14.1207 -5.91477 -4.02646 -8264 4 49.1323 34.6374 15.219 24.748 6.82197 2.94942 -8265 6 46.275 5.00035 11.1282 9.7079 18.7279 -10.06 -8266 4 45.8191 4.20733 11.3912 -11.1099 -14.8598 8.88229 -8267 4 46.9633 4.71614 10.5231 1.70636 -6.51939 -1.67277 -8268 6 33.7833 38.63 35.3851 22.6491 -26.5736 53.3982 -8269 4 34.0604 38.9625 36.3013 -14.2885 -2.00103 -44.5517 -8270 4 33.6201 39.3455 34.786 -2.63152 22.0909 -4.2817 -8271 6 30.8201 25.8435 41.2101 0.522631 -30.718 -12.9218 -8272 4 31.0968 24.9266 41.4082 -1.05643 6.85883 -6.1679 -8273 4 31.1715 26.3436 0.016995 6.66556 20.3816 22.2796 -8274 6 50.2276 0.978128 24.4598 74.6558 22.0158 36.8282 -8275 4 49.5306 0.534407 24.0585 -38.5843 -30.8873 -31.929 -8276 4 51.1134 0.532188 24.3239 -37.6779 9.32343 -0.630533 -8277 6 31.2996 0.720873 19.0302 14.3507 40.5737 -10.6901 -8278 4 30.4605 0.743437 18.5837 -16.9464 -9.10756 -3.3833 -8279 4 31.3343 41.8987 19.5933 -6.31648 -47.867 22.0648 -8280 6 39.0778 29.5479 19.1423 -24.9794 -6.4558 -1.7207 -8281 4 38.1293 29.5816 19.4551 33.1986 -8.08964 -3.40762 -8282 4 39.446 28.6506 19.2986 -6.02354 14.8003 0.990496 -8283 6 21.659 17.5991 25.8953 -11.5386 33.2832 -7.33353 -8284 4 22.0418 18.5204 25.967 -8.02723 -30.5851 6.12101 -8285 4 20.778 17.7492 25.4824 18.7799 -9.30112 4.66445 -8286 6 35.0777 28.803 27.4254 -1.70316 -21.0069 37.4458 -8287 4 35.3301 29.4791 28.0775 3.3924 -2.39002 -8.5847 -8288 4 35.0935 29.2141 26.5843 6.79083 21.8236 -32.9604 -8289 6 30.7137 25.4449 11.6588 -11.4017 25.922 39.321 -8290 4 30.5753 25.9017 12.5616 8.60864 -26.5127 -36.0552 -8291 4 30.5331 26.1452 11.022 4.69716 -0.666916 0.479504 -8292 6 7.33812 15.1344 12.3538 4.68116 -40.544 31.6975 -8293 4 6.75693 14.3594 12.209 2.06777 16.361 -3.14284 -8294 4 7.31295 15.622 11.5607 -9.0052 27.071 -31.8075 -8295 6 16.8334 26.8188 7.04972 -25.5936 3.66279 -30.8653 -8296 4 17.5758 26.708 7.59816 38.4339 -11.2263 23.8467 -8297 4 17.1819 26.9966 6.1597 -5.58153 -2.73835 6.66814 -8298 6 29.5302 33.0784 31.0001 -37.3865 -15.0005 -19.6245 -8299 4 28.6433 32.7554 30.7459 2.04647 15.9344 -4.27919 -8300 4 29.8764 32.2746 31.3613 18.5632 -10.7791 20.7082 -8301 6 14.1048 2.11879 30.9099 -3.69766 -14.7615 43.6071 -8302 4 14.1458 1.95878 31.9138 -8.46722 9.63961 -39.7078 -8303 4 13.6642 1.31591 30.5661 9.09938 8.95306 -0.112961 -8304 6 15.6571 22.2632 2.89617 -37.5764 43.5932 -9.62192 -8305 4 16.4348 21.7941 3.05118 39.5293 -34.0009 4.7875 -8306 4 15.0286 21.6897 2.4522 -3.10464 -12.538 6.06705 -8307 6 23.7259 29.1153 40.9645 17.3396 38.8389 1.6287 -8308 4 23.2818 30.0193 40.9831 11.4767 -32.1544 -0.906545 -8309 4 24.7087 29.2887 40.9216 -25.4222 -7.32646 2.20707 -8310 6 38.1247 14.1642 13.7107 12.8592 31.0763 6.54808 -8311 4 37.6278 13.3808 13.8383 -17.8092 -31.0521 2.1891 -8312 4 38.9029 13.9224 13.2095 7.41852 -3.42228 -8.90759 -8313 6 35.2503 26.5068 15.521 -3.09354 13.3371 19.8917 -8314 4 34.5349 26.5126 14.8818 -0.932758 -4.81772 -4.34805 -8315 4 34.9075 27.0382 16.2823 10.0491 -13.0104 -19.4153 -8316 6 19.0968 34.7379 16.486 5.71756 23.995 22.7437 -8317 4 19.4075 35.6523 16.3704 4.72819 -11.1284 17.3551 -8318 4 19.0401 34.4508 15.6072 -6.41662 -20.6903 -39.0731 -8319 6 18.1723 29.7514 35.7083 20.6671 12.6318 -10.71 -8320 4 18.3041 30.5743 35.1773 -7.60682 -14.8418 20.474 -8321 4 19.0351 29.5718 36.145 -10.3356 2.9076 -6.19235 -8322 6 54.1213 22.2675 24.9131 12.7342 -33.1199 -26.8219 -8323 4 53.6265 21.7967 24.1967 9.15099 10.4438 12.7736 -8324 4 53.5183 22.8995 25.2476 -23.1208 24.5105 7.38222 -8325 6 30.3446 10.3415 34.0026 7.84994 -0.761596 -9.91104 -8326 4 29.5868 10.4349 34.5739 -14.9697 1.07498 11.7851 -8327 4 30.8511 11.1643 34.0933 -4.52293 -3.62201 3.70872 -8328 6 38.3178 33.8965 18.5989 -35.8058 -11.4104 -3.76591 -8329 4 38.923 33.166 18.7063 19.7544 -4.29321 9.06839 -8330 4 38.8137 34.6503 18.3352 23.7539 21.4454 3.52643 -8331 6 22.4873 14.1653 34.4312 -21.9658 -17.0918 -49.1801 -8332 4 22.5571 13.4626 33.7145 -4.81718 29.7264 22.473 -8333 4 23.0772 13.8965 35.1058 26.7449 -1.29975 22.8703 -8334 6 38.021 0.617904 2.36461 -2.26574 -7.91048 -40.4777 -8335 4 37.6239 1.19646 3.0125 3.99393 1.59858 23.4614 -8336 4 38.7851 0.132723 2.71367 -6.22024 4.30596 13.4956 -8337 6 38.885 41.133 10.292 38.4397 69.693 -20.9517 -8338 4 38.7327 0.223589 10.3334 0.502898 -40.1285 -2.38265 -8339 4 38.1678 40.7662 10.7395 -40.074 -22.1176 34.0334 -8340 6 53.417 21.9266 38.962 18.4876 1.53578 17.2983 -8341 4 52.9974 21.8755 38.1026 3.71535 5.74942 -10.4205 -8342 4 54.37 22.1639 38.7939 -25.8904 -11.793 -3.59034 -8343 6 39.9933 12.7125 36.2959 -18.8272 27.1562 12.2819 -8344 4 39.0734 12.4542 36.2547 -7.90274 -1.75871 9.35878 -8345 4 40.3901 12.0873 35.7283 26.8007 -18.4843 -23.2317 -8346 6 48.44 17.2431 40.5981 -19.9836 6.93831 4.04917 -8347 4 47.6199 17.7956 40.4399 22.5854 -23.5642 7.97707 -8348 4 48.3147 16.8142 41.4747 5.07747 10.2388 -9.33604 -8349 6 32.0284 9.3439 40.0151 10.5149 -12.1651 13.6504 -8350 4 32.8546 9.41316 39.523 -1.99935 -3.17675 -6.39298 -8351 4 31.9706 8.39334 40.2816 -10.0936 21.7982 -4.27543 -8352 6 31.75 22.4929 6.3685 -34.2181 3.54143 23.53 -8353 4 31.3779 21.709 6.82557 12.2201 6.35834 -11.7559 -8354 4 31.3059 23.2194 6.8777 16.0591 -13.7554 -15.3432 -8355 6 51.0144 2.58529 21.579 28.4772 -3.64411 10.4611 -8356 4 51.4343 1.72703 21.8198 -11.0001 9.38403 -4.71992 -8357 4 51.7571 3.20177 21.4507 -11.3685 -6.83795 2.38662 -8358 6 13.6247 22.0465 12.1442 29.0901 0.46256 9.76546 -8359 4 14.4578 22.3795 12.5465 -13.9989 1.27328 -8.95219 -8360 4 12.915 22.6494 12.3833 -3.04453 8.5056 -1.94564 -8361 6 23.6209 24.0381 14.6453 -17.5202 11.834 -36.5316 -8362 4 24.2009 24.4886 15.2598 9.8869 4.60732 -3.70937 -8363 4 23.5497 24.6116 13.8304 3.00595 -20.2815 30.972 -8364 6 9.32136 4.85156 31.2387 8.97842 0.466865 -3.67014 -8365 4 8.41764 4.8259 30.9291 -8.7496 -0.132795 -7.84821 -8366 4 9.23666 5.38964 32.029 2.44443 -3.9247 9.21777 -8367 6 16.6769 26.3146 18.0426 -28.7898 -24.0576 -1.25383 -8368 4 15.7763 26.5978 17.7405 22.2361 3.17889 2.46191 -8369 4 17.2688 27.0532 17.9767 7.52301 23.5471 -7.71583 -8370 6 5.12002 13.5179 11.5454 -28.2867 15.553 -42.5279 -8371 4 4.34318 13.4159 12.0982 -3.89331 -5.54815 13.62 -8372 4 4.69334 13.8537 10.6805 23.3071 -7.58808 40.5266 -8373 6 29.613 23.6535 8.07622 4.06305 -5.39054 -18.0309 -8374 4 29.2087 23.3655 8.89798 -2.48969 6.78204 1.65997 -8375 4 29.356 24.5861 7.97247 8.33853 -10.6544 5.22118 -8376 6 0.809058 7.56442 27.8431 6.90575 4.16885 -14.0934 -8377 4 0.916059 7.33161 28.7668 -1.2645 -7.40385 9.39857 -8378 4 1.47033 8.27499 27.7095 -9.19662 -21.8408 -1.77541 -8379 6 15.4183 9.78145 0.490529 10.0725 -7.13925 0.979932 -8380 4 16.087 9.43012 41.8027 -0.259761 -4.12548 -6.98761 -8381 4 15.4693 9.20893 1.26423 -1.27146 5.63374 6.96511 -8382 6 18.8191 0.059487 34.1187 -25.6574 -0.396319 -31.4644 -8383 4 18.4098 41.5755 33.3103 16.2128 4.97009 18.3796 -8384 4 18.5054 0.975155 34.0945 0.533414 5.37151 1.64989 -8385 6 18.7349 30.7803 29.1665 47.4813 -67.7405 25.7886 -8386 4 19.5534 30.6866 29.7899 -42.3671 12.2249 -32.0712 -8387 4 18.5184 31.6699 29.0545 -8.91834 48.7901 3.3651 -8388 6 48.4474 16.4903 36.136 -4.39653 9.55775 -4.4164 -8389 4 47.5651 16.9082 36.2181 15.0357 -0.381514 0.207393 -8390 4 48.471 16.1274 35.2331 3.08724 1.10756 7.15907 -8391 6 43.7979 0.472205 29.2706 42.555 -4.96452 -15.1149 -8392 4 42.8863 0.267919 29.38 -32.9664 -6.64218 10.9475 -8393 4 44.2792 41.5357 29.3524 -8.26894 11.2804 8.78801 -8394 6 16.7205 13.887 21.3769 2.19577 2.66609 -2.49996 -8395 4 16.2052 14.7022 21.5336 6.85381 -11.1318 0.719729 -8396 4 16.6911 13.4037 22.2072 -6.06459 1.50462 5.19021 -8397 6 17.3883 13.4356 26.2524 27.4966 3.2637 -26.6685 -8398 4 18.1303 13.5822 25.5825 -26.8694 -2.13737 32.6247 -8399 4 17.6394 12.6216 26.7148 -3.51452 -0.718268 0.201186 -8400 6 48.1557 10.2329 23.6958 7.66187 -11.6345 21.9365 -8401 4 48.0869 10.5828 24.5972 -4.20109 -8.3855 -4.21906 -8402 4 47.9242 10.9774 23.1563 3.12678 5.33996 -12.4543 -8403 6 28.2651 17.9126 17.8865 15.704 23.8601 -19.8805 -8404 4 29.0328 18.4581 17.6288 -8.16305 -6.08358 1.86534 -8405 4 28.6272 17.0995 18.2183 0.672722 -20.799 10.0784 -8406 6 54.0866 38.1772 23.6885 15.2416 -7.03948 -9.32302 -8407 4 0.015845 37.9236 23.4759 -13.1891 10.5947 7.1207 -8408 4 53.5403 37.6177 23.1226 -4.14834 -2.69562 5.50015 -8409 6 8.47885 18.3973 11.4073 -18.4373 -13.8141 42.9629 -8410 4 7.63335 18.6519 11.0416 -6.40415 6.02722 -6.48684 -8411 4 9.12927 18.583 10.7796 32.3175 8.52747 -41.6205 -8412 6 45.9451 12.8796 11.0371 -17.0736 -2.86831 -37.3051 -8413 4 46.6905 12.613 10.4807 4.61659 2.073 6.35499 -8414 4 45.2044 12.775 10.3831 8.06265 2.44535 24.075 -8415 6 16.2127 8.79404 14.0297 41.7324 -66.6139 22.361 -8416 4 15.4739 9.28873 13.8367 -45.7772 50.9633 -18.0772 -8417 4 17.0286 9.27652 14.012 9.93977 26.888 -8.08533 -8418 6 42.7214 13.3612 21.3881 16.6788 44.7105 -2.77317 -8419 4 41.8036 13.1589 21.3301 -20.1042 -28.5105 -1.62877 -8420 4 42.6833 14.2978 21.1276 5.52546 -8.26362 1.62797 -8421 6 21.0018 40.4256 16.4674 21.2457 -19.0828 1.73859 -8422 4 20.7372 40.049 17.3276 2.67731 3.65462 -7.46566 -8423 4 21.8606 39.9985 16.1939 -29.0987 10.293 9.55187 -8424 6 45.6337 11.4313 32.9356 51.1157 -40.0447 2.01383 -8425 4 46.3303 10.7696 33.2563 -29.172 28.0234 -20.2541 -8426 4 45.1866 11.676 33.7277 -20.3741 9.53259 21.5498 -8427 6 26.9484 8.87146 24.2965 48.4346 1.85391 18.4292 -8428 4 27.5311 9.68141 24.3337 -29.9021 -15.2605 -8.39328 -8429 4 27.4823 8.26118 24.8676 -16.4416 6.67878 -12.0087 -8430 6 18.977 2.43413 29.3663 0.758316 16.52 -7.40381 -8431 4 18.1944 2.4248 29.9271 -0.767207 -2.12047 7.99903 -8432 4 19.1173 3.36872 29.101 -3.03797 -9.07666 7.57415 -8433 6 8.2454 29.1679 19.723 -8.63488 -12.9151 21.1286 -8434 4 8.14448 28.8871 20.6627 3.14293 7.67545 -21.2948 -8435 4 7.83715 28.464 19.1969 -1.03495 3.62674 2.54809 -8436 6 9.03976 34.3129 18.6533 -7.54593 -6.72093 -3.09965 -8437 4 8.77081 34.2931 19.577 -0.177883 2.97642 -7.59668 -8438 4 9.06659 35.2455 18.4187 6.50563 1.62734 -4.46359 -8439 6 10.1892 11.9266 11.2355 -21.5107 11.0325 -1.739 -8440 4 10.2333 12.874 11.065 17.4692 -2.43612 -1.88546 -8441 4 9.23632 11.7983 11.121 5.09535 -6.80078 4.24402 -8442 6 35.7546 21.6858 36.1669 -23.2352 21.9394 0.834429 -8443 4 35.0265 22.3595 36.1433 18.2091 -18.4066 2.26802 -8444 4 36.3924 22.0173 36.8321 -9.99636 -6.87572 -9.75527 -8445 6 17.0812 12.5048 36.3903 -12.1142 25.6516 12.5185 -8446 4 17.3175 12.8308 37.2812 -0.49448 -9.18651 -10.1264 -8447 4 17.5662 11.7075 36.2155 7.76979 -20.5663 -1.07791 -8448 6 37.1566 13.0227 34.2843 -17.9764 -6.1284 -55.2853 -8449 4 36.5549 12.2662 34.3472 4.68366 1.60167 -17.3784 -8450 4 37.3932 13.1268 35.1567 14.9075 13.7384 64.605 -8451 6 38.9862 29.5501 13.2301 -1.89389 21.6683 -7.70005 -8452 4 38.7944 28.7085 12.8419 -2.19861 -17.9948 -10.7911 -8453 4 38.6501 29.4932 14.1174 1.27468 3.77518 16.782 -8454 6 0.176516 29.3495 29.4845 -12.5141 10.2637 -5.31555 -8455 4 0.737394 28.6151 29.2028 3.82179 3.49987 -8.15609 -8456 4 54.9814 29.9211 28.6995 5.57042 -17.7863 13.6106 -8457 6 15.9458 0.256833 12.7596 -44.0073 4.56069 2.48191 -8458 4 15.316 0.578271 12.0799 19.6091 -0.692249 -3.06606 -8459 4 15.3039 41.7798 13.3939 19.5978 -0.7471 3.56907 -8460 6 3.99127 11.9482 8.78851 -15.4327 -39.7622 32.4444 -8461 4 4.35413 11.6179 7.97869 6.27746 3.41828 -23.4587 -8462 4 3.98972 12.8788 8.75552 1.02746 43.1268 -6.73396 -8463 6 24.041 23.6822 19.9783 33.1595 11.366 0.122861 -8464 4 23.6132 22.8866 19.7159 -20.0299 -17.1205 -2.84168 -8465 4 23.4218 24.2757 20.3917 -9.46777 4.2557 4.80954 -8466 6 4.48057 2.29323 23.9805 -22.9759 10.1361 69.4322 -8467 4 4.73792 2.40802 23.1034 3.49419 10.2026 -52.1527 -8468 4 3.69711 2.85929 24.1902 11.7092 -10.5693 -13.4065 -8469 6 33.0966 27.663 33.8386 -28.073 -12.9468 -7.71443 -8470 4 33.3687 28.5694 33.7309 6.85765 13.8135 -2.76136 -8471 4 33.7449 27.1385 34.2981 13.436 1.78162 12.2729 -8472 6 11.3912 21.7129 6.08719 -17.5666 -2.19741 -2.39462 -8473 4 12.3323 21.6847 6.05692 28.5529 -3.65784 2.285 -8474 4 11.1694 22.1681 5.26899 -4.22105 -2.6604 -2.39966 -8475 6 37.2225 13.5364 23.6261 -18.6729 23.2035 4.88571 -8476 4 37.3138 14.0862 24.4412 -7.0733 -14.7121 -13.3014 -8477 4 37.9734 12.9786 23.5155 30.7338 -8.31921 -1.90296 -8478 6 5.00503 21.0366 33.3647 1.8453 38.5327 -33.3657 -8479 4 4.21257 21.4237 32.9267 15.1329 -13.9269 -2.57683 -8480 4 4.69097 20.5075 34.0602 -12.1996 -25.3348 31.8286 -8481 6 18.1998 37.5792 26.9379 10.6598 2.97497 -14.5277 -8482 4 17.7896 38.4267 27.1371 3.99806 -1.69574 -0.528064 -8483 4 18.8493 37.7746 26.2284 -6.0853 -8.42077 12.5802 -8484 6 19.7447 16.1537 4.6847 3.25094 -1.99961 -5.02271 -8485 4 18.927 15.8729 5.11398 3.02189 5.09699 3.93014 -8486 4 20.4865 15.8366 5.22215 -5.31395 3.35724 3.77112 -8487 6 54.074 32.5125 15.5854 10.3761 -37.3618 -30.9158 -8488 4 54.8842 32.2065 16.0104 -1.29748 4.29224 -6.87141 -8489 4 53.7047 33.0976 16.2003 -18.9781 34.1452 25.1436 -8490 6 31.1314 3.81684 36.7321 -0.834289 -2.49025 -7.10722 -8491 4 31.1103 4.02948 37.6722 -6.54843 -2.60835 4.18586 -8492 4 30.7135 2.95482 36.5673 3.74099 5.55874 7.56308 -8493 6 11.8386 14.3591 5.9475 31.6488 6.08621 47.6135 -8494 4 11.9235 13.4381 5.72501 -3.84758 -8.60837 -9.73648 -8495 4 12.4264 14.4198 6.78937 -30.0453 0.761866 -39.8937 -8496 6 30.4739 33.6971 6.46755 -23.3776 20.1936 16.0158 -8497 4 30.0841 33.0849 7.09297 -6.22519 -2.1618 10.9649 -8498 4 31.0937 33.1726 6.0102 25.8315 -23.5027 -25.5745 -8499 6 12.7945 0.536645 21.6661 -31.9857 18.4102 -14.2222 -8500 4 12.046 0.975194 21.1709 21.6431 -18.6961 6.09473 -8501 4 12.7507 0.998686 22.5059 13.427 -0.157027 11.5383 -8502 6 52.7685 7.22113 26.1957 6.97037 27.5507 21.845 -8503 4 53.4259 7.92282 26.4698 -21.5773 -21.2317 -16.9414 -8504 4 53.0823 6.78628 25.4103 4.46247 -3.68205 -10.7225 -8505 6 39.7279 40.8849 3.7445 22.9677 17.8938 -40.8272 -8506 4 39.3244 40.0392 3.76563 -12.6427 -25.5287 10.0743 -8507 4 39.6614 41.3038 4.58361 -3.65945 6.85452 27.763 -8508 6 20.1085 31.9188 21.9984 -7.05206 -5.67602 7.13377 -8509 4 19.4287 32.0842 22.6964 14.9272 -8.91322 -13.6161 -8510 4 20.3617 32.7769 21.6609 2.64243 15.0084 0.0829653 -8511 6 12.8674 35.0052 4.44359 43.5281 -46.0898 9.1613 -8512 4 12.2643 35.7062 4.40975 -34.4326 42.8527 -2.74399 -8513 4 13.784 35.3443 4.35073 -14.7319 6.47242 -4.65586 -8514 6 24.0589 33.6612 24.8588 9.55704 11.7193 -6.52578 -8515 4 23.7303 32.9012 24.3903 -5.13736 -12.3884 -10.0474 -8516 4 24.8786 33.8838 24.3903 -2.58553 -1.28908 -1.69824 -8517 6 40.1426 40.9082 22.7393 38.5538 -20.8809 37.5387 -8518 4 39.5402 41.0833 22.0513 -32.6743 7.60774 -19.3027 -8519 4 39.6696 40.5795 23.5226 -1.01773 2.4492 -9.99125 -8520 6 15.5532 2.81426 38.4448 -20.0738 34.0709 23.3703 -8521 4 14.8967 3.48174 38.7749 9.17215 -23.4566 -12.8824 -8522 4 16.1607 3.33672 37.9186 19.8661 -0.634992 -1.43825 -8523 6 41.016 9.18565 16.9561 17.4117 -10.7022 -18.9926 -8524 4 41.8597 8.69641 16.8054 -9.41989 12.8418 6.23764 -8525 4 40.6131 8.73354 17.6887 -9.17188 -2.41438 15.2761 -8526 6 43.1923 41.3931 9.58697 -22.3356 -19.1489 -3.62619 -8527 4 42.3612 40.9845 9.24256 14.3618 0.824315 8.65898 -8528 4 43.3433 0.185675 8.9708 1.58778 19.1204 -6.9238 -8529 6 24.903 37.9158 30.7914 -43.8554 -5.41491 21.3724 -8530 4 23.952 37.804 31.173 48.4757 4.96182 -14.1951 -8531 4 24.7905 38.4252 29.9913 -4.69729 3.46822 -12.8277 -8532 6 2.22055 5.32897 16.4318 -0.704957 11.5959 2.51569 -8533 4 1.8086 4.56809 16.8519 3.25773 -6.94195 4.1641 -8534 4 3.17492 5.17974 16.3235 -2.45649 -10.6256 -1.35481 -8535 6 1.39662 14.9371 19.1386 6.71081 10.2639 18.1623 -8536 4 0.558182 14.6006 18.8448 -10.0768 -10.7254 -15.2923 -8537 4 1.25744 14.8844 20.1022 8.06638 5.64899 -3.4629 -8538 6 34.3184 26.5435 23.7018 12.956 38.2174 -10.8067 -8539 4 33.6096 26.6326 23.0506 -6.28704 -5.42218 7.19498 -8540 4 34.253 25.729 24.1673 -8.0715 -30.4977 4.91012 -8541 6 41.932 21.8144 37.5476 -28.1346 24.458 10.6264 -8542 4 41.9653 21.2973 38.3662 8.82952 -0.726087 -9.88338 -8543 4 41.2985 22.5209 37.8344 14.7394 -10.5077 -10.9774 -8544 6 39.4289 37.6722 12.6363 -7.06663 36.6798 -8.56095 -8545 4 38.7214 38.0767 13.1674 9.12422 -13.2372 3.4836 -8546 4 39.8791 38.4903 12.2996 -0.376717 -30.7746 7.3995 -8547 6 30.2308 35.8744 2.88429 56.3256 -5.17531 19.584 -8548 4 29.7395 35.078 2.8871 -14.5394 -27.2578 -4.40621 -8549 4 29.6846 36.541 2.55195 -33.266 39.3858 -14.7027 -8550 6 50.3691 12.2996 11.0379 -10.7742 -32.245 -38.7061 -8551 4 50.5492 13.1381 11.4098 4.20277 26.7051 25.7379 -8552 4 50.0731 11.6929 11.7162 -2.05651 -3.66514 15.0978 -8553 6 38.4203 1.52686 34.6552 6.3891 -23.1477 32.9209 -8554 4 38.2942 1.9363 33.8354 -7.66336 30.6162 -40.7111 -8555 4 38.1079 0.632206 34.5078 -6.35148 -11.0336 -1.97829 -8556 6 23.4679 32.2557 29.2149 -43.4567 -12.6916 53.2324 -8557 4 24.0296 32.8423 28.7424 12.6247 17.2837 -9.6693 -8558 4 23.1232 32.6929 30.0761 24.9901 -11.6617 -44.232 -8559 6 36.561 38.8488 8.89417 42.7368 2.70764 46.8348 -8560 4 35.962 39.5202 8.64255 -29.9788 24.4889 -23.0747 -8561 4 36.8832 39.1244 9.78764 -11.193 -6.37855 -17.8717 -8562 6 35.882 15.8491 32.4345 4.38917 24.4094 -11.8898 -8563 4 36.1253 15.4284 33.2547 4.1797 -3.844 11.2859 -8564 4 36.4849 16.63 32.3181 -12.6028 -21.8682 2.29862 -8565 6 22.2747 21.8257 41.5848 1.63659 45.0851 -0.0273952 -8566 4 22.1351 22.8132 41.5538 -4.13496 -33.3395 13.1468 -8567 4 23.0832 21.7834 41.079 15.3069 -18.439 -3.51535 -8568 6 24.3693 38.6933 37.0124 5.99709 22.8296 -9.01594 -8569 4 25.2224 39.1901 37.0147 -13.2325 -18.2305 -0.0611307 -8570 4 24.4452 38.0141 37.6805 1.8393 -10.9749 7.25289 -8571 6 45.85 22.0674 16.0435 -6.35855 -11.009 -33.5755 -8572 4 46.1693 22.2375 15.1223 -5.70657 5.73574 25.2515 -8573 4 45.3177 21.2496 15.9445 13.424 8.98362 5.88408 -8574 6 34.0938 26.1451 39.6028 29.3502 -8.72422 32.5359 -8575 4 33.1775 26.2044 39.4639 -36.6108 3.5864 -15.8394 -8576 4 34.1454 26.1252 40.583 9.60862 3.8872 -14.9166 -8577 6 7.22316 36.161 23.2803 -75.9344 2.48999 -44.2827 -8578 4 7.2061 37.0658 22.9632 2.60813 8.07149 -4.69042 -8579 4 7.98979 36.1134 23.7455 79.8131 -8.28428 52.3852 -8580 6 29.1469 40.7664 9.14908 25.9603 -62.9641 -41.536 -8581 4 29.104 40.2522 8.28913 -11.1672 35.4313 19.904 -8582 4 29.7179 40.1086 9.59652 -3.22944 23.7461 21.8778 -8583 6 29.3725 11.2348 1.3024 -38.7794 14.8627 17.4065 -8584 4 28.4703 11.3821 0.891273 31.6728 -0.63192 16.6295 -8585 4 29.2803 11.4968 2.26097 5.36173 -12.1272 -32.3877 -8586 6 30.9813 3.70043 14.0775 0.393287 -12.1193 -7.6118 -8587 4 31.3533 2.81844 14.3971 -7.37725 32.1126 -17.4345 -8588 4 30.796 3.71521 13.098 8.52465 -17.2224 25.8707 -8589 6 29.7018 15.2871 38.2765 -11.7342 18.5436 -44.4423 -8590 4 30.2882 15.1814 38.9925 24.3773 -7.28175 32.8118 -8591 4 30.1059 15.9805 37.6877 -12.7379 -16.9908 17.8861 -8592 6 36.618 0.316233 29.1564 -1.13478 17.6011 -18.8673 -8593 4 37.4497 0.805382 29.2328 -0.537074 -5.31334 10.7084 -8594 4 36.0611 0.935156 28.6408 3.38103 -20.3125 11.7491 -8595 6 47.6566 0.117823 23.249 5.11875 5.73062 -10.5794 -8596 4 46.969 0.414744 23.8324 -12.4062 9.53281 16.9836 -8597 4 47.4018 41.1354 23.0496 0.315762 -17.3342 0.264415 -8598 6 7.91605 37.1729 29.9478 9.96828 38.7234 29.3851 -8599 4 7.8238 37.3188 30.9485 4.22886 -13.4646 -46.5453 -8600 4 8.48708 37.9472 29.6677 -24.8232 -29.7333 9.09982 -8601 6 38.925 24.2263 12.6374 28.6028 -18.1679 -25.4959 -8602 4 37.978 24.1747 12.7226 -16.6271 -1.4443 2.40459 -8603 4 39.1586 23.5255 11.9538 -9.24307 26.9603 22.464 -8604 6 21.3053 26.2545 36.7859 14.9917 45.9325 1.16 -8605 4 20.8074 25.7232 36.1994 -14.2562 -21.9874 -17.8757 -8606 4 21.6248 25.6951 37.4625 3.91421 -21.0802 23.8691 -8607 6 28.2258 23.3284 24.9888 19.6442 1.87868 9.60148 -8608 4 28.2493 24.0261 25.6588 -3.93467 -3.60043 -2.01642 -8609 4 29.1002 22.8932 25.0573 -18.3502 1.43704 -4.70914 -8610 6 38.4116 39.5691 14.5896 29.669 -4.24194 25.1928 -8611 4 38.4978 38.8692 15.3261 -6.52385 31.9806 -37.1925 -8612 4 39.2924 40.0897 14.6163 -46.5668 -30.9815 -6.21074 -8613 6 26.0432 5.99751 38.1148 44.5658 1.98351 30.7371 -8614 4 26.452 6.86444 38.1066 -12.5768 15.2327 -11.4433 -8615 4 26.7959 5.51316 38.5398 -27.2991 -6.53191 -16.0548 -8616 6 52.1237 17.2497 22.5073 -27.4301 16.765 14.7973 -8617 4 52.9399 17.665 22.2571 16.5652 5.20466 -11.3284 -8618 4 52.1578 16.3131 22.3678 7.8945 -19.2066 -9.92552 -8619 6 39.5302 30.1999 31.4498 -15.3908 2.56685 75.4769 -8620 4 40.0207 30.5437 32.2484 0.473519 -4.28305 -35.1019 -8621 4 38.713 29.8928 31.926 18.6512 10.8404 -28.7426 -8622 6 19.6503 6.93083 12.7623 15.8343 -24.4908 21.6207 -8623 4 19.8732 6.46228 13.5959 -20.1786 11.9342 -5.76682 -8624 4 20.303 6.55009 12.1776 -0.0209149 2.55819 -14.5973 -8625 6 32.4196 37.4972 40.0987 12.4446 10.4582 -32.0511 -8626 4 32.8186 36.647 40.0719 9.51079 -23.9505 -16.9607 -8627 4 32.1638 37.519 40.9804 -20.9873 13.1856 56.2462 -8628 6 39.7646 0.344956 6.09395 -0.813604 -13.3118 11.6504 -8629 4 40.0929 1.25666 6.05063 3.72657 -6.06719 5.14874 -8630 4 40.1279 41.7919 6.88268 -2.2039 13.7644 -10.8213 -8631 6 28.7754 10.1494 29.1547 6.27663 8.45441 -17.0952 -8632 4 27.8341 10.1814 28.9557 -5.13507 -0.906004 3.81537 -8633 4 28.9096 9.91312 30.0774 -3.02611 -6.60467 -0.689697 -8634 6 28.3509 21.0738 10.6423 20.1214 -0.517468 -23.7169 -8635 4 28.7452 21.9678 10.604 -10.1652 -7.70852 11.001 -8636 4 28.9796 20.5469 10.1008 -17.263 7.26144 14.8814 -8637 6 27.0689 28.6853 20.8654 35.4789 -5.63144 4.47554 -8638 4 27.7442 29.2307 21.3162 -7.53329 -4.62114 -3.00727 -8639 4 26.2324 28.9644 21.1916 -29.8949 8.87289 15.491 -8640 6 39.6884 13.9755 33.4499 14.6401 2.99861 16.5486 -8641 4 40.0373 13.7827 34.3426 -3.85296 -1.51256 -14.2832 -8642 4 38.7457 13.8219 33.5285 -9.87208 -9.87778 -3.27097 -8643 6 25.4679 11.6581 34.316 -5.2989 -28.5582 40.5924 -8644 4 24.7613 11.1605 34.7897 20.9725 -0.466275 -6.59756 -8645 4 25.003 12.0579 33.6214 -16.717 25.3404 -32.2266 -8646 6 27.5101 37.647 21.4263 -39.7295 -31.2682 -35.969 -8647 4 28.2375 37.1633 21.0518 17.2189 -6.02702 -9.55939 -8648 4 27.8241 38.1534 22.1272 30.3423 24.6719 41.8853 -8649 6 30.5838 20.0489 28.6446 73.221 13.9737 -1.42059 -8650 4 31.1441 19.3945 29.1273 -28.9524 12.9537 -8.0961 -8651 4 29.6632 19.9528 28.6439 -45.0502 -19.2043 6.90743 -8652 6 42.3833 1.8554 14.9243 13.367 3.08275 38.4467 -8653 4 41.8907 2.29225 15.634 5.99337 6.74303 1.17955 -8654 4 41.7769 1.84183 14.2131 -17.6385 -4.20156 -32.9301 -8655 6 12.1633 12.5377 19.5325 -23.0245 -19.867 -11.1113 -8656 4 12.9521 12.0237 19.3369 9.43068 0.576721 5.46819 -8657 4 11.4219 11.8853 19.4518 12.4737 16.4774 1.27947 -8658 6 19.216 1.20416 16.3541 12.5689 2.54581 22.2585 -8659 4 19.6937 0.628292 16.9879 -4.91383 6.35485 -14.1526 -8660 4 19.7889 1.98236 16.2594 -2.22189 -4.72354 -7.2618 -8661 6 9.47695 16.1439 27.6873 23.0793 15.684 -40.8775 -8662 4 9.87411 15.9669 26.7875 -8.00596 11.4199 30.6292 -8663 4 9.27844 15.2819 28.0019 -12.6146 -24.0632 14.4486 -8664 6 40.4558 26.1873 24.7848 -5.87099 -8.07067 -10.9608 -8665 4 40.3772 26.6753 25.6381 -3.45584 0.121614 -18.2296 -8666 4 40.075 26.6842 24.0102 9.21367 0.234889 33.0434 -8667 6 47.6742 17.6493 18.027 -37.0889 26.6143 -3.73366 -8668 4 48.2089 18.0323 18.7522 -4.76487 -3.2939 -8.20899 -8669 4 46.8388 18.2201 17.9217 41.9344 -19.3622 12.4897 -8670 6 36.6073 25.2802 4.19388 18.2149 -9.73143 -24.5863 -8671 4 36.604 25.3887 5.14943 -0.00537736 13.7381 3.83127 -8672 4 37.3627 25.7621 3.76942 -18.9403 0.329358 18.8416 -8673 6 39.5721 35.375 29.6682 7.39129 29.0443 4.37935 -8674 4 38.9992 34.6325 29.7528 -8.39079 -18.7886 -5.10368 -8675 4 39.3389 35.9401 30.4162 6.41301 -4.37294 -4.4287 -8676 6 0.402862 14.6299 13.3406 12.3375 -5.37043 -32.3015 -8677 4 54.737 15.2477 13.6388 -5.18731 7.44473 4.40324 -8678 4 0.540834 14.0191 14.0401 1.19186 -14.994 25.3978 -8679 6 12.2127 27.3484 8.43247 -29.2387 -0.771708 1.75024 -8680 4 12.965 26.7512 8.46983 14.5311 5.0326 6.8656 -8681 4 12.3156 28.1607 8.97491 11.1816 -11.3427 -11.9337 -8682 6 36.8986 14.8167 21.1188 31.0797 27.7575 -31.2238 -8683 4 37.0397 14.394 21.9547 2.6333 -10.7207 26.6181 -8684 4 37.7308 15.3371 20.9125 -24.2604 -24.0664 4.77074 -8685 6 20.8464 4.94114 21.1044 31.4042 5.97012 13.2179 -8686 4 20.3644 5.60924 21.5958 -5.50293 4.43366 -4.7096 -8687 4 21.773 5.03668 21.4416 -23.5272 -13.3128 -11.683 -8688 6 36.7544 1.79945 7.61694 -30.3574 47.6061 45.3867 -8689 4 36.327 2.6686 7.87118 16.8784 -26.1974 -29.8241 -8690 4 36.8428 1.50799 8.53455 15.1793 -22.3797 -11.8231 -8691 6 12.2439 31.5023 37.4569 -32.4985 -2.96535 6.06153 -8692 4 12.7586 31.1596 36.7365 10.4364 1.05198 -9.11954 -8693 4 11.3919 31.0227 37.3953 11.2973 8.58078 9.3944 -8694 6 38.9908 41.586 16.881 -5.73716 8.1645 -10.5856 -8695 4 39.3046 41.7073 15.9766 4.30886 -9.33368 3.06156 -8696 4 39.3667 0.405687 17.3669 3.77504 10.3777 9.96207 -8697 6 31.8904 27.2678 22.2602 -2.97266 4.85738 -46.2508 -8698 4 31.2122 26.6002 22.3915 1.88455 0.488126 10.0993 -8699 4 31.7489 27.4981 21.2895 3.71213 -3.79941 38.8104 -8700 6 42.7405 9.18554 25.589 -22.1194 -12.6454 -9.25487 -8701 4 42.0872 8.82691 24.9599 0.650449 1.17306 7.26361 -8702 4 43.4011 9.54846 25.0154 21.3216 10.0262 -4.62936 -8703 6 50.9383 28.1736 25.3544 -13.6318 0.0171378 28.1732 -8704 4 50.4953 27.5553 24.7803 -5.9639 1.72187 -15.2616 -8705 4 50.5272 27.9992 26.2251 14.2447 5.57945 -12.3971 -8706 6 43.1888 19.6578 30.9105 -66.6531 23.7889 25.5358 -8707 4 44.0873 19.829 30.8982 70.1332 9.75906 -5.84371 -8708 4 42.7965 20.4661 31.3425 9.97757 -17.7871 -10.1322 -8709 6 30.6644 14.0457 40.7997 -18.1309 16.7334 54.243 -8710 4 30.3214 14.3504 41.7092 15.0959 -2.90855 -40.5845 -8711 4 30.1739 13.231 40.7145 -1.19418 -16.8866 -12.4659 -8712 6 20.9131 15.4897 23.0235 5.61878 12.7036 12.8066 -8713 4 20.368 16.1905 23.4302 1.66694 -9.32372 -6.67403 -8714 4 21.8218 15.751 23.2692 -7.37195 -9.57776 -6.18749 -8715 6 34.2171 0.764056 35.8253 8.40959 -35.3498 44.9304 -8716 4 34.6567 1.46863 36.3417 -5.08936 -9.30099 -7.81199 -8717 4 34.1194 41.866 36.4755 2.29033 39.9746 -37.3302 -8718 6 38.9162 36.9098 35.9203 10.0793 6.80115 3.36275 -8719 4 39.7784 37.1612 36.3284 -16.0364 -11.2649 -5.21842 -8720 4 38.6132 36.0588 36.2696 9.66804 2.35098 0.533126 -8721 6 45.1336 25.2146 22.7744 -28.8992 3.863 21.2581 -8722 4 44.1561 25.0943 22.7165 17.1243 8.87651 18.653 -8723 4 45.3983 24.7563 22.0047 17.0602 -12.3694 -29.5411 -8724 6 40.597 0.8134 35.9421 3.227 69.6319 -3.88491 -8725 4 40.5509 41.8059 36.0096 -6.03355 -53.2669 -4.53187 -8726 4 39.9427 1.13471 35.2813 10.0151 -17.6297 16.5691 -8727 6 11.0455 28.3465 35.0235 9.7668 1.71998 -0.601403 -8728 4 10.9819 27.7367 35.7737 -0.960779 4.073 1.47136 -8729 4 10.3922 29.0422 35.1677 -11.8786 -4.48184 3.12795 -8730 6 20.2051 13.5934 35.8566 39.7213 -43.4527 45.4399 -8731 4 19.4813 14.0017 35.4777 -48.9883 30.031 -35.164 -8732 4 20.9868 14.0394 35.5673 14.4182 15.1 -18.5178 -8733 6 39.6245 5.13776 1.76997 -0.951619 9.89005 21.073 -8734 4 38.8252 4.77089 1.41386 -14.9185 -6.12031 -3.7056 -8735 4 40.3018 4.93211 1.13633 15.4903 5.30459 -14.5773 -8736 6 30.2698 30.8736 32.4375 -6.71798 15.6036 14.0469 -8737 4 29.6901 31.1438 33.1751 5.76607 1.99955 -8.25679 -8738 4 29.7896 30.1731 32.0039 1.14172 -17.9152 -6.50707 -8739 6 14.5598 11.0088 22.8703 10.5759 -0.53797 13.7125 -8740 4 15.2344 11.6195 23.3114 -32.0235 -23.0075 -11.5695 -8741 4 13.848 10.7777 23.5118 19.1574 10.2796 -1.34673 -8742 6 20.7379 13.9443 3.00881 5.16887 -45.0314 -26.4616 -8743 4 19.9261 13.6658 2.50706 22.866 18.233 23.793 -8744 4 20.5244 14.6819 3.55007 -16.1173 25.3417 12.2311 -8745 6 41.3029 4.28468 12.6203 -8.04128 10.917 21.7417 -8746 4 40.6152 3.63858 12.7642 -6.82471 -4.23516 2.09603 -8747 4 41.6484 4.11485 11.7651 11.719 -9.67534 -28.974 -8748 6 10.8581 24.7328 21.7161 -39.3585 -15.8792 -33.4515 -8749 4 10.0068 24.8598 21.1989 28.1112 14.2693 20.1969 -8750 4 11.1639 23.9123 21.3137 10.3572 -6.50453 7.69671 -8751 6 53.5762 20.8825 34.3773 -29.6915 -0.0415475 -3.94304 -8752 4 54.5085 20.795 34.3185 33.8519 4.29786 -2.30511 -8753 4 53.2552 20.0612 34.7861 8.83511 12.9473 -9.59804 -8754 6 14.8838 4.84499 30.449 -1.65326 0.839716 -13.8987 -8755 4 14.8578 5.00753 29.4799 -4.93385 -7.75961 17.951 -8756 4 14.5437 3.94124 30.5804 2.28716 7.27432 -2.63088 -8757 6 48.9137 37.1159 13.1232 -44.1315 32.6594 -31.0851 -8758 4 47.9268 37.1149 13.1949 24.5681 4.85746 10.1076 -8759 4 49.2024 36.4546 13.7037 17.9017 -30.2536 24.0784 -8760 6 26.8017 19.3068 7.5379 -15.1037 -1.6612 14.6377 -8761 4 27.3245 18.5243 7.34583 -2.01051 -6.65035 -9.19035 -8762 4 27.3053 20.0577 7.2492 18.4232 10.5976 -10.0514 -8763 6 17.631 11.9383 39.0904 -43.3265 13.8677 10.122 -8764 4 18.4941 11.6307 38.9203 38.4816 -13.6738 2.54756 -8765 4 17.5009 12.0978 40.0481 6.31677 -1.58465 -10.4285 -8766 6 49.9233 14.5931 8.61354 5.83785 -36.2985 -8.08798 -8767 4 49.214 13.9285 8.60404 6.89175 6.08198 5.75816 -8768 4 49.5175 15.3796 8.93642 -5.42274 33.9852 6.11405 -8769 6 32.3642 34.9667 31.5078 2.95354 23.7899 20.5819 -8770 4 32.072 34.4222 30.8036 -4.84614 -18.7532 -16.6478 -8771 4 32.4643 35.8463 31.1217 -0.970967 -0.757054 5.3462 -8772 6 11.8286 22.2266 21.3061 -17.2258 -15.6378 -41.9552 -8773 4 12.2171 21.6669 20.5638 -11.8041 19.7065 26.8676 -8774 4 12.3859 22.1258 22.0497 29.6948 -3.02551 21.8379 -8775 6 33.8509 9.96106 13.6416 -14.3875 -24.3714 -53.1057 -8776 4 33.0123 9.50508 13.4028 8.15621 17.9807 22.2309 -8777 4 34.3201 9.78154 12.7883 7.50726 12.1846 28.7729 -8778 6 25.5192 36.3946 1.51103 -10.4602 3.19395 -11.4439 -8779 4 26.0842 36.7323 0.810141 8.62195 6.50952 5.56913 -8780 4 24.6933 36.9065 1.40961 6.72848 -10.059 1.65156 -8781 6 26.2721 10.5411 9.76409 -19.2005 -4.19702 2.88354 -8782 4 25.6096 11.193 9.42675 5.9346 -6.99241 18.1855 -8783 4 25.839 9.94226 10.4354 7.43867 25.8511 -14.7334 -8784 6 25.016 0.794303 40.8954 13.3669 6.17095 4.00755 -8785 4 25.3682 0.342397 40.1084 -6.19889 9.04785 1.09472 -8786 4 25.4075 1.69244 40.9338 -2.19893 -14.7289 -5.24662 -8787 6 46.2434 3.93626 24.8203 6.94819 -22.6825 -8.03363 -8788 4 46.3834 4.04208 23.8743 3.61713 6.01616 -2.12387 -8789 4 46.2394 2.96647 24.9181 -8.37252 7.22853 3.62774 -8790 6 21.5889 13.6037 29.2057 4.95103 8.76674 17.4208 -8791 4 21.6019 14.3052 29.8879 -2.51331 -9.966 -5.68557 -8792 4 21.3126 14.082 28.4253 -2.16645 0.501775 -6.52993 -8793 6 36.7737 38.3803 0.360926 -13.0762 -25.442 -6.6792 -8794 4 36.4499 39.0355 0.978203 -4.80976 12.188 0.88021 -8795 4 36.0266 37.7487 0.22189 15.835 12.8395 4.19355 -8796 6 19.3086 17.6338 24.0617 47.0109 35.6134 -17.5995 -8797 4 18.4263 17.3722 24.1632 -50.3154 -15.1751 2.93786 -8798 4 19.3137 18.3511 23.365 -2.62926 -22.9616 14.087 -8799 6 23.1803 12.6945 3.50697 -12.4047 4.12184 -0.296296 -8800 4 22.2521 12.9621 3.30307 10.5621 -3.58256 -0.535563 -8801 4 23.3663 11.8631 3.0578 -9.23841 -1.30096 -1.53094 -8802 6 37.8891 8.88353 35.4651 -18.9945 -25.3999 -47.3866 -8803 4 38.8166 8.83127 35.1934 2.77199 2.98421 7.2207 -8804 4 37.4068 8.32521 34.752 23.9265 29.6152 37.0755 -8805 6 14.3237 15.1253 36.1844 10.7536 -1.62675 -12.1114 -8806 4 15.0418 15.7291 36.3902 7.37284 -3.65767 0.0646607 -8807 4 13.765 15.154 36.9379 -17.7819 2.51157 18.8211 -8808 6 35.0801 0.941274 33.018 -10.8249 30.7834 33.3167 -8809 4 34.9269 1.883 33.2395 6.71896 -7.58638 -28.1375 -8810 4 34.9733 0.615676 33.9226 0.339269 -19.4543 -11.259 -8811 6 50.9271 0.518298 17.9933 -4.01299 -8.33658 -1.61011 -8812 4 50.7551 1.39133 17.5891 -0.713529 -12.5397 8.99793 -8813 4 50.17 41.8323 17.8017 14.8721 13.6567 -6.57092 -8814 6 26.2328 30.5636 0.934374 -8.95911 39.2037 50.9017 -8815 4 26.9657 31.1139 1.27364 -12.5333 -13.1029 -5.86431 -8816 4 26.5352 30.0815 0.207089 19.4446 -20.9762 -37.1203 -8817 6 18.5681 38.3031 4.5613 16.0408 -0.4472 -12.493 -8818 4 17.6336 38.3732 4.40187 -16.7548 5.85511 1.82222 -8819 4 18.9561 38.7121 3.75593 -0.616515 -6.35836 15.3023 -8820 6 31.1349 5.07457 4.1166 35.5071 -12.4218 -11.0008 -8821 4 31.9258 4.61163 4.53765 -37.2933 13.7034 -13.5003 -8822 4 31.2792 5.02565 3.1391 -9.10044 -1.2591 17.9933 -8823 6 26.4378 21.892 1.49191 0.117022 -23.7737 9.75083 -8824 4 26.3504 22.7277 1.07049 4.38069 30.3527 -12.7348 -8825 4 27.3618 21.6023 1.50897 -0.762137 4.81239 -9.09803 -8826 6 39.2154 11.7026 22.7855 15.1366 1.14561 24.1899 -8827 4 39.8619 11.6546 23.5153 -3.42244 7.72178 -8.31759 -8828 4 38.7922 10.855 22.8508 -11.0077 -10.6036 -7.38167 -8829 6 13.6049 36.3215 30.6697 16.8779 70.0034 -37.8159 -8830 4 13.9417 37.1302 31.1268 -10.116 -30.1168 -5.71441 -8831 4 13.4922 35.6039 31.2515 -3.36872 -19.2676 30.0327 -8832 6 50.5831 9.86782 9.34675 -39.9446 -18.2052 0.719337 -8833 4 49.679 9.5553 9.65542 27.7691 6.62521 -8.8993 -8834 4 50.7343 10.6656 9.84378 7.47556 12.1458 9.31829 -8835 6 49.6659 40.3022 22.5839 -5.95569 -23.2057 2.00246 -8836 4 49.9088 39.3695 22.3976 1.04597 17.1639 -6.42107 -8837 4 49.3089 40.2511 23.4853 9.00681 3.37443 -0.55643 -8838 6 7.21026 41.318 28.8937 -13.882 28.5523 32.2899 -8839 4 7.13277 41.6426 29.851 5.74914 -19.7174 -37.6289 -8840 4 7.14599 0.215754 28.3517 11.7183 -8.26627 3.5395 -8841 6 13.0317 18.008 25.3351 57.1177 45.3919 41.6622 -8842 4 13.702 18.0765 24.6297 -18.9881 -2.87884 -2.05071 -8843 4 13.5608 18.5052 26.1022 -41.5403 -41.2906 -37.5185 -8844 6 50.0508 19.5822 2.43378 8.05757 -12.3534 -25.4868 -8845 4 50.6415 19.2321 1.70522 -9.91294 15.3245 28.3035 -8846 4 50.4964 20.3068 2.88656 9.48594 2.0046 -2.18375 -8847 6 28.3417 40.9623 24.5247 28.1527 -9.28969 -2.11238 -8848 4 28.8808 40.6229 23.7869 -8.53201 1.00989 5.926 -8849 4 27.851 41.6822 24.1702 -24.0642 17.3603 -12.6153 -8850 6 19.4173 5.36544 29.5282 -16.7292 -1.42659 17.4998 -8851 4 20.0576 6.03033 29.2802 12.6037 1.87093 -5.71578 -8852 4 18.8017 5.84191 30.1159 0.735032 -8.12986 -7.95209 -8853 6 35.3107 40.1454 22.2712 -2.40765 19.7984 -7.699 -8854 4 35.7006 39.9699 23.1142 6.54418 -16.9762 14.0951 -8855 4 35.2702 41.1078 22.294 -0.592679 0.794763 -5.20647 -8856 6 16.1889 33.7724 9.7458 10.3229 10.2088 29.582 -8857 4 15.8959 33.2543 9.01299 -6.07516 -13.8809 -16.7379 -8858 4 15.6715 34.5759 9.82028 -7.73583 2.776 -7.11592 -8859 6 17.3675 40.6445 20.2267 0.0256395 24.2963 -9.09373 -8860 4 17.2094 39.7816 20.6122 1.5629 -5.58702 6.23448 -8861 4 17.4758 41.3298 20.9152 1.51783 -13.2527 0.49298 -8862 6 20.5171 9.72867 9.58726 35.059 7.05341 -25.1666 -8863 4 21.2226 9.96362 10.213 -13.2653 -0.810893 -5.91795 -8864 4 19.8248 9.38464 10.113 -26.7953 -13.816 19.6743 -8865 6 47.4426 20.1922 21.3765 55.2231 -18.8128 34.629 -8866 4 48.295 19.6294 21.3384 -41.3243 22.9169 -3.74061 -8867 4 46.9816 20.0754 20.5659 -14.9725 -5.50706 -31.0177 -8868 6 38.4071 40.79 37.8146 12.3234 -22.6201 -9.80787 -8869 4 38.1404 41.7017 37.8605 -3.64711 23.1989 -4.06141 -8870 4 38.2696 40.4362 38.6954 -10.1247 -0.131598 9.15413 -8871 6 4.78578 1.94641 13.1038 0.280311 5.55092 -8.42179 -8872 4 4.79931 1.2475 12.4246 2.88607 5.75183 11.0778 -8873 4 4.58324 1.57529 13.9639 -2.31824 -10.9024 4.61034 -8874 6 46.8249 29.0091 2.16845 3.76482 2.94797 40.2579 -8875 4 46.7332 29.1215 3.14399 -15.0191 0.321828 -28.5005 -8876 4 47.6691 28.5689 2.15078 10.7116 -9.65214 -17.1948 -8877 6 37.4359 26.1653 25.6478 9.30824 1.4869 -5.75173 -8878 4 37.1837 25.5346 26.3178 -5.80587 -7.25577 3.90549 -8879 4 36.6384 26.5534 25.3025 -7.59782 4.42715 -0.0787482 -8880 6 27.3269 4.19583 19.442 5.96538 17.8772 -24.7701 -8881 4 28.0114 4.58146 18.8428 -3.77368 -14.8915 15.8068 -8882 4 26.5277 4.61529 19.0816 -6.14884 -6.84507 9.70558 -8883 6 29.57 35.1706 32.6629 9.65469 -19.4491 -13.9626 -8884 4 29.5306 34.4116 32.0191 -0.1659 24.8691 21.1709 -8885 4 30.4743 35.5004 32.5856 -0.51053 -0.290213 -2.43375 -8886 6 51.6097 27.3863 34.6091 -31.2455 30.913 9.06642 -8887 4 51.929 26.6019 35 16.42 -40.5282 7.55135 -8888 4 52.0725 27.582 33.8009 7.9649 -1.59603 -13.3915 -8889 6 26.2078 15.7281 22.6941 16.538 -21.7488 31.7554 -8890 4 25.9667 16.5615 22.3191 -8.70869 23.0893 -12.8942 -8891 4 26.0629 14.9994 22.0993 -9.54979 -3.97748 -17.7982 -8892 6 36.1239 41.1986 15.4707 -7.45359 -19.8962 -4.3143 -8893 4 35.6999 40.3419 15.2987 -9.47391 11.3121 -0.409552 -8894 4 37.0386 40.9374 15.4513 15.7433 3.85103 -0.545832 -8895 6 18.465 8.81345 11.2165 5.38391 10.0618 1.17025 -8896 4 18.7987 8.15135 11.8182 8.53154 -1.35082 11.1952 -8897 4 17.7161 8.38168 10.8393 -16.7411 -2.38381 -11.2186 -8898 6 30.2088 21.3096 23.2049 -11.6688 7.62645 -9.73036 -8899 4 29.9671 22.1993 22.9248 4.97058 -0.914249 3.78278 -8900 4 29.5299 20.7541 22.7893 7.94877 -1.13118 2.47612 -8901 6 22.73 2.20521 34.8374 1.74432 -25.8699 49.3747 -8902 4 22.3572 1.29354 34.8889 6.16039 22.5731 -10.8251 -8903 4 22.7018 2.4887 33.9486 -6.75325 10.5307 -40.1895 -8904 6 12.6909 2.75059 12.3422 -14.3125 16.3183 -13.6311 -8905 4 12.533 3.61796 11.8786 11.7453 -23.2619 14.9881 -8906 4 13.1336 2.19907 11.6816 1.83842 1.45343 3.2847 -8907 6 24.107 30.0639 14.5719 -73.5796 11.8292 4.65098 -8908 4 23.699 30.7611 15.1345 32.1371 -0.343623 -0.31889 -8909 4 23.2337 29.7156 14.2286 43.085 -3.68866 -7.89372 -8910 6 0.015177 27.9048 22.8533 -2.756 -4.53229 -2.63487 -8911 4 54.6492 28.3778 23.623 -8.36257 -3.01834 -6.1652 -8912 4 54.216 27.6514 22.3224 8.23112 8.70814 10.2495 -8913 6 12.3617 4.4844 25.9108 40.9735 -25.7794 -17.3291 -8914 4 12.201 5.40791 25.8162 -22.6464 21.2272 1.21762 -8915 4 11.6198 4.00067 26.267 -15.5784 4.93476 10.9426 -8916 6 50.6578 14.4652 5.91353 -13.9437 -6.30553 43.3918 -8917 4 51.4397 15.014 5.76935 2.55266 2.90763 -3.8133 -8918 4 50.4787 14.4827 6.92851 9.15248 3.54798 -49.9389 -8919 6 52.5668 22.873 20.1428 -12.6564 -29.9263 -28.8801 -8920 4 52.956 23.3393 20.8718 4.45243 13.9606 14.107 -8921 4 52.7899 23.3428 19.3246 -0.129831 10.341 11.583 -8922 6 43.5892 16.524 12.8775 29.595 -3.78245 -19.1347 -8923 4 44.3058 16.0087 12.3806 -28.6005 27.9094 23.6723 -8924 4 42.7982 16.4888 12.3437 -11.2315 -8.54457 -10.2035 -8925 6 15.9661 16.7487 40.5866 1.44034 32.7745 -1.20572 -8926 4 16.4126 17.3388 39.9207 -12.1014 -18.8104 17.452 -8927 4 15.5985 17.3766 41.2587 12.5036 -14.614 -16.5617 -8928 6 23.4158 18.8712 23.8473 -16.0774 -11.4939 3.2157 -8929 4 23.4518 19.2692 24.728 -0.157295 3.62127 -3.85719 -8930 4 22.4941 18.9757 23.5436 12.0607 -0.266031 2.57498 -8931 6 46.4178 3.27548 31.8952 19.5415 -1.29071 -17.2416 -8932 4 45.5866 3.26999 31.4067 -8.61336 -0.166695 4.01481 -8933 4 46.2657 3.3297 32.8359 -5.35267 1.32166 2.09612 -8934 6 43.4045 41.0584 12.2875 -8.04746 -23.5947 4.76735 -8935 4 43.6693 41.8276 12.7696 6.05224 12.9314 10.8988 -8936 4 43.5172 41.2728 11.3626 0.904796 3.93503 -13.2342 -8937 6 7.4976 32.4756 29.5884 -13.7893 55.6862 -12.0377 -8938 4 8.07142 31.7837 29.8334 27.4303 -26.9633 6.13269 -8939 4 8.04212 33.3166 29.512 -13.0153 -27.2422 -1.65156 -8940 6 4.77821 31.644 22.4997 2.28771 28.4048 16.4959 -8941 4 5.27411 32.2412 23.0928 2.56389 -13.4484 -8.63656 -8942 4 4.12057 32.2584 22.1518 -1.39427 -10.0394 -7.16978 -8943 6 48.879 26.8662 2.67919 -5.86075 -60.7959 24.9619 -8944 4 49.7001 26.7095 3.23946 -26.2991 7.4186 -32.0291 -8945 4 48.3448 25.9902 2.75892 28.4546 51.6452 -6.88552 -8946 6 35.3626 23.261 21.6242 -2.7789 -2.57103 6.54281 -8947 4 36.2261 22.8974 21.81 4.94258 -15.6751 6.88864 -8948 4 35.5426 23.9136 20.9639 -1.02428 17.548 -23.8062 -8949 6 9.79934 37.7758 27.3048 16.52 16.637 17.9603 -8950 4 9.72643 38.6113 27.803 -16.1555 -8.36248 -12.7831 -8951 4 10.5885 37.4189 27.7206 -2.15823 -16.4776 -5.60851 -8952 6 6.95685 10.9812 25.9821 -25.178 -21.2877 -4.97438 -8953 4 6.33357 10.2528 25.7268 23.179 21.9129 0.503821 -8954 4 7.29095 10.6974 26.8328 9.60603 -1.481 14.6966 -8955 6 15.9965 34.4888 38.9273 -2.91878 -3.91161 19.3063 -8956 4 16.0374 33.5463 38.7461 4.95306 -0.665665 -16.4822 -8957 4 15.9715 34.4958 39.9054 -7.59103 5.72172 -22.2107 -8958 6 24.1167 17.3197 36.1615 15.3363 -47.5124 0.380375 -8959 4 24.7173 17.5753 36.8648 1.58194 5.49031 12.5141 -8960 4 24.1546 16.3101 36.2205 -9.7187 30.8811 -7.11116 -8961 6 29.9757 19.0472 5.63639 12.788 -31.6225 11.2379 -8962 4 30.1584 18.5328 6.46799 -12.7316 12.501 -21.5451 -8963 4 29.4206 19.7916 5.84051 -11.4929 16.6696 15.0892 -8964 6 41.2293 14.2018 25.873 -1.75888 28.9255 -23.3251 -8965 4 41.1078 15.0995 25.4693 3.83492 -22.0907 13.098 -8966 4 41.2654 14.3268 26.8215 3.7207 5.50516 9.94654 -8967 6 30.6006 17.7874 37.3562 -24.7598 46.8721 10.074 -8968 4 30.0173 18.4181 36.8416 23.2796 -25.9316 -1.25214 -8969 4 30.633 18.2764 38.2118 8.15578 -14.795 -8.30511 -8970 6 36.2662 35.7599 28.8527 -12.8707 -30.9202 21.2821 -8971 4 36.6718 34.9534 29.2396 -10.1595 12.442 -4.1956 -8972 4 37.0218 36.2801 28.6478 17.3511 22.2532 -11.5483 -8973 6 0.195836 37.8645 20.3851 -23.6217 6.21569 -13.9532 -8974 4 0.549498 37.2778 21.0637 4.94615 -2.95215 -2.70832 -8975 4 54.3862 37.4234 20.0075 16.4722 8.11718 6.90773 -8976 6 49.5165 39.5896 25.2714 -0.622408 -34.3922 32.9891 -8977 4 49.1772 39.7667 26.1925 10.9208 -1.11318 -32.3029 -8978 4 49.8261 38.6352 25.2806 -10.9036 35.658 1.81375 -8979 6 21.6574 10.1952 29.3538 -5.06277 -0.743802 10.2318 -8980 4 21.4664 11.1105 29.223 -3.01111 19.5458 -20.3057 -8981 4 21.662 10.2064 30.3052 9.73006 -17.7161 13.8831 -8982 6 36.4636 30.0567 0.119709 9.37859 61.6807 38.5429 -8983 4 36.3123 29.4684 41.3206 -1.21017 -23.1836 -37.505 -8984 4 36.9143 30.908 41.7057 -13.4567 -39.5067 4.20368 -8985 6 35.2344 23.3726 39.1433 31.8417 -88.9919 -51.9106 -8986 4 35.0278 23.5012 38.2069 -5.96056 -5.38998 8.96032 -8987 4 34.9909 24.127 39.538 -31.8308 96.9265 45.0865 -8988 6 25.4761 17.6258 38.7257 1.29934 8.28965 -16.1346 -8989 4 26.2031 17.0769 39.0234 13.7946 -6.33455 1.86524 -8990 4 25.7107 18.4933 39.0598 1.3782 7.33891 4.86011 -8991 6 32.6846 1.71002 15.3734 -11.6254 -20.3205 21.5399 -8992 4 32.9453 1.93093 16.3086 -8.96834 -8.53877 -20.2534 -8993 4 32.154 0.853232 15.3925 19.204 32.1949 4.36426 -8994 6 2.7574 26.2382 40.1716 -4.40087 -21.6692 -50.7652 -8995 4 2.38718 26.7949 40.8139 -8.13358 26.7101 38.7547 -8996 4 3.41358 25.6429 40.5298 13.0891 -5.49009 7.80053 -8997 6 25.4307 39.5752 6.64887 -26.4755 -1.32722 14.1102 -8998 4 25.8932 39.0809 7.30961 27.038 -6.17916 -3.25304 -8999 4 24.5458 39.4465 7.03066 -2.44587 12.932 -21.9634 -9000 6 3.88975 2.45855 21.1879 28.3389 -91.355 -25.6726 -9001 4 3.44478 1.54109 20.9736 25.4092 48.4753 9.01111 -9002 4 3.19228 2.99847 21.4284 -47.2055 43.8768 12.3888 -9003 6 19.4353 35.9908 6.17834 -1.98144 -11.1023 18.0698 -9004 4 18.7425 35.7628 6.83514 2.39623 12.5316 -16.1317 -9005 4 19.0828 36.5127 5.45195 -11.0597 11.4176 1.1294 -9006 6 53.664 10.8386 34.7899 -0.427116 -3.27611 41.7292 -9007 4 53.6105 10.6836 35.7561 -1.66612 -17.5448 -26.7849 -9008 4 53.9652 11.7272 34.8329 4.68725 29.9217 -18.2793 -9009 6 51.2799 14.0867 34.6651 -29.2798 -10.9719 -23.3019 -9010 4 50.6522 13.5411 34.1107 26.8684 18.9114 5.01949 -9011 4 50.9895 13.8814 35.5479 1.81167 -5.08277 17.6681 -9012 6 14.4338 40.0198 28.0288 -0.147098 23.5255 27.6002 -9013 4 13.7688 39.3521 27.8218 1.28331 -8.25373 7.75106 -9014 4 14.1948 40.5222 28.8704 -0.878391 -19.6822 -29.209 -9015 6 36.0552 40.8569 1.29319 48.4065 13.1893 15.2608 -9016 4 35.4421 41.0883 1.96787 -21.4185 -0.412662 13.5205 -9017 4 36.896 41.2683 1.66088 -27.5471 -12.7345 -18.5843 -9018 6 32.5846 21.8706 9.62772 14.4951 6.80277 0.680584 -9019 4 32.1936 21.3098 8.97285 -7.2875 -23.9506 -7.81502 -9020 4 32.858 22.6104 9.08324 0.955029 10.0343 1.40437 -9021 6 53.7602 11.4574 10.0748 -7.70253 -4.89045 -17.0247 -9022 4 54.6558 11.7035 10.3272 3.70339 -10.2166 -5.16833 -9023 4 53.8328 10.8374 9.31644 -2.27357 5.83713 13.9933 -9024 6 25.443 2.0669 35.0212 -16.7533 17.7231 -21.4763 -9025 4 25.6415 2.91576 34.5502 -7.64634 -16.7974 11.4347 -9026 4 24.4652 2.09352 35.1703 17.3945 -2.11295 -4.26167 -9027 6 38.4088 16.3775 27.0777 23.4896 -26.556 7.92078 -9028 4 38.4029 15.905 27.9411 -0.72651 18.7119 -5.4255 -9029 4 38.1233 17.2789 27.1678 -4.67214 15.3602 11.0072 -9030 6 11.9834 11.8283 38.0863 1.50515 -20.9897 -19.5245 -9031 4 12.337 12.445 38.7318 -5.05033 4.06408 7.46746 -9032 4 11.0493 11.6049 38.244 7.06215 11.5652 6.68382 -9033 6 21.1646 40.7247 25.8949 30.8575 -6.32012 -20.5276 -9034 4 20.7152 41.4784 25.5554 -14.4662 20.9939 -18.0031 -9035 4 20.8194 40.6451 26.758 -13.9443 -15.9826 36.5019 -9036 6 5.45737 31.2526 28.1092 12.1805 15.5126 -2.48606 -9037 4 4.77986 31.7446 27.6301 0.776808 -0.764161 -8.53258 -9038 4 6.21204 31.8695 28.2031 -7.61365 -6.18966 7.74582 -9039 6 38.5666 10.4345 26.6322 12.4833 -8.23035 1.5222 -9040 4 39.2815 10.9281 26.2104 -2.91177 1.8082 -0.00903947 -9041 4 39.0293 9.89744 27.2937 -7.88948 5.75886 -1.98766 -9042 6 34.5704 22.2441 5.77364 -5.35359 -6.12765 6.5276 -9043 4 33.6261 22.329 6.01336 10.9983 8.59631 1.2651 -9044 4 35.1361 22.6291 6.46875 -10.1328 -5.43064 -4.61746 -9045 6 19.508 23.4157 8.91293 -5.78488 4.73981 5.04963 -9046 4 19.7274 23.1974 9.83518 1.16663 -6.94775 -9.92836 -9047 4 19.9131 22.8043 8.29809 9.12387 -6.1547 2.91491 -9048 6 19.7424 39.1606 18.9462 6.36032 12.2479 8.14591 -9049 4 20.3561 39.0422 19.6872 -3.85164 -4.35394 -5.20149 -9050 4 19.0738 39.7495 19.3414 -1.06489 -8.07777 -11.9442 -9051 6 19.0057 16.6591 37.8853 37.3334 -16.7993 4.17439 -9052 4 18.1861 16.4809 37.4823 -32.8062 -2.38488 -19.1553 -9053 4 18.8146 17.2984 38.5514 -2.10283 15.4454 14.1988 -9054 6 46.1541 18.3125 34.4675 -16.9871 7.29415 15.254 -9055 4 46.1595 17.7325 33.7168 0.615393 -10.1859 -17.2384 -9056 4 45.2376 18.6499 34.5058 9.28079 -5.03019 -2.85447 -9057 6 37.6537 4.93165 10.635 20.1552 -8.04423 -16.7256 -9058 4 38.5399 5.21744 10.272 -26.6503 -7.30776 7.98139 -9059 4 37.1074 4.55852 9.88971 22.9932 21.6332 27.1334 -9060 6 51.9792 36.004 6.8478 30.791 3.18545 -0.726681 -9061 4 52.2413 36.7963 6.35992 -14.9215 -4.55469 -2.53046 -9062 4 52.8266 35.8818 7.33626 -22.3254 6.63746 5.40006 -9063 6 26.6741 12.3268 1.0034 -10.7024 -25.4666 -34.2692 -9064 4 26.4988 12.3574 1.94138 -4.81655 1.43394 14.8604 -9065 4 26.0954 11.585 0.663483 16.9242 17.5219 15.4646 -9066 6 51.3423 35.7724 13.5298 -0.266216 29.5034 10.6004 -9067 4 51.4043 36.4131 12.804 2.34884 -4.4098 -1.45811 -9068 4 51.4073 34.9167 13.1542 5.41074 -27.2154 -15.541 -9069 6 1.98873 3.64285 24.5869 25.9971 69.8048 -55.2188 -9070 4 1.65752 3.03018 25.1632 -30.3002 -46.9535 54.3289 -9071 4 1.71436 4.54846 24.8879 2.6309 -26.2008 -0.982747 -9072 6 33.5221 15.2795 16.4506 0.0536135 -15.838 -38.1617 -9073 4 33.6476 15.3964 15.4593 -8.63578 3.82522 35.1416 -9074 4 33.7341 16.1085 16.8736 8.85342 14.4801 4.37501 -9075 6 10.7227 26.5775 37.3442 -67.903 54.2831 -20.645 -9076 4 10.2191 27.0779 38.0369 14.5194 -13.2702 -3.80745 -9077 4 11.4784 26.2608 37.7268 68.0232 -30.094 41.6962 -9078 6 39.6271 8.38119 31.999 1.44949 -5.13238 35.1009 -9079 4 39.1996 8.85287 32.7464 5.61163 -5.5592 -21.3265 -9080 4 39.0885 8.45634 31.2221 -15.3514 9.3045 -12.0182 -9081 6 48.873 24.2439 11.5987 1.10357 -37.2725 -9.21005 -9082 4 49.1825 23.3167 11.4023 -5.65288 27.9965 8.32055 -9083 4 49.5986 24.6511 12.0826 3.19491 3.15896 -2.50749 -9084 6 15.8098 8.51994 22.5326 -12.5814 0.672941 2.19285 -9085 4 15.7588 8.52265 21.5683 10.3815 2.49136 4.36748 -9086 4 15.4206 9.36801 22.7863 6.5895 4.65597 -0.371293 -9087 6 16.9392 23.5364 7.95083 25.1749 21.5498 -34.0775 -9088 4 17.2079 23.9031 7.093 -25.8979 -5.01679 3.50755 -9089 4 17.8126 23.4623 8.29573 16.7216 -7.09478 32.6865 -9090 6 42.4825 26.8555 6.33102 0.60087 7.54144 -12.7632 -9091 4 41.764 27.4892 6.46083 9.75026 1.01062 3.5184 -9092 4 43.14 27.3488 5.78659 -9.42643 -3.33158 7.6404 -9093 6 36.8078 4.79995 30.0438 -4.74249 18.2042 -3.85385 -9094 4 36.952 4.89746 30.9922 3.10706 -1.8894 0.559973 -9095 4 36.294 4.02131 29.8808 -10.4691 -15.4659 3.71438 -9096 6 45.6128 11.6142 3.31163 15.5246 21.1623 13.6733 -9097 4 45.8972 10.701 3.31117 0.727629 -14.3179 7.30305 -9098 4 46.2501 12.0834 3.90994 -13.3278 -10.7206 -15.6492 -9099 6 24.8943 36.3842 21.2731 0.145584 -0.0155718 21.9832 -9100 4 24.5073 36.3627 22.1568 -5.92138 3.86098 -2.91089 -9101 4 25.79 36.6624 21.4916 7.30899 1.2523 -13.3669 -9102 6 31.8172 24.7218 2.44079 24.9542 32.077 -0.738567 -9103 4 31.5948 23.8911 2.82575 -7.26237 -24.1795 3.52598 -9104 4 32.7966 24.7848 2.51706 -20.2581 -1.29655 -5.98664 -9105 6 24.135 21.9795 37.225 -18.6422 57.7065 19.5247 -9106 4 24.1223 22.9841 37.1061 1.06209 -41.2434 9.50937 -9107 4 24.7129 21.6948 36.5371 13.1815 -12.7877 -24.1492 -9108 6 37.1979 11.5342 15.06 20.8972 -17.7328 -40.5152 -9109 4 38.0246 11.7972 15.4709 -1.33045 5.21986 19.7962 -9110 4 36.429 11.9138 15.4438 -18.178 22.6449 25.793 -9111 6 36.4751 20.3399 41.7845 -26.5497 -48.0551 41.2862 -9112 4 36.3228 19.4621 41.3748 1.60744 11.8178 -3.29004 -9113 4 36.9246 20.873 41.191 27.5593 28.4699 -43.2619 -9114 6 32.0497 37.9214 32.6612 -32.2386 -8.50634 -18.7459 -9115 4 32.4337 38.7163 32.9803 20.8647 20.5609 12.2985 -9116 4 31.3654 38.2694 32.0613 5.31663 -14.2519 5.69849 -9117 6 12.0395 39.928 22.5123 -26.9832 36.7812 23.3187 -9118 4 12.2839 40.8414 22.1926 -3.01474 -29.6796 4.86816 -9119 4 11.2932 40.0883 23.1662 29.524 -10.585 -25.0576 -9120 6 26.3406 1.33526 19.2893 15.6729 -20.8034 13.8388 -9121 4 26.8411 0.655996 19.8199 -14.5491 24.9752 -14.9066 -9122 4 26.8003 2.1813 19.3861 0.112049 0.00336314 -1.02908 -9123 6 5.91669 14.3164 5.69097 2.29729 -16.5161 -30.3395 -9124 4 6.30102 14.1024 4.7902 -6.32478 5.25084 23.5077 -9125 4 5.06552 13.8494 5.70115 7.33482 -6.30923 1.55114 -9126 6 13.3703 23.089 19.1627 -28.3895 15.3871 14.4757 -9127 4 14.1086 22.8122 18.6632 27.2898 -8.01563 -16.6587 -9128 4 13.6991 23.742 19.8005 3.67942 -13.964 0.879599 -9129 6 23.4058 15.0688 9.73621 -4.11719 1.06855 12.2005 -9130 4 22.5732 14.661 10.02 0.657405 4.9462 -7.25364 -9131 4 23.2196 15.7347 9.05868 -5.70535 0.38861 -5.0655 -9132 6 49.5812 13.8288 18.4474 0.101153 1.0527 41.008 -9133 4 48.8214 13.4814 17.9923 -8.96247 -7.71084 -15.1851 -9134 4 50.2052 14.1722 17.8367 10.7879 13.5653 -33.2962 -9135 6 41.7444 5.67096 41.8915 25.5819 0.859229 17.1787 -9136 4 42.5704 5.9364 0.475256 -21.6624 -6.74737 -14.5764 -9137 4 42.0361 4.9893 41.2645 -5.04703 6.59959 -2.77397 -9138 6 17.2492 35.5437 2.55512 -4.98919 17.2489 6.23124 -9139 4 18.1963 35.629 2.41282 7.59523 -3.20753 1.41995 -9140 4 16.9663 34.6563 2.38439 4.57262 -16.6324 -5.73806 -9141 6 49.6936 19.8647 40.242 36.1149 -8.05295 1.41344 -9142 4 49.24 19.0314 40.466 10.1916 2.45634 3.62304 -9143 4 50.6901 19.7225 40.3055 -34.6505 -2.12616 -4.55887 -9144 6 38.3055 5.83107 32.0437 -25.1209 3.13983 17.5072 -9145 4 37.8566 6.51058 32.5952 5.57321 -12.5864 -8.78808 -9146 4 39.2068 6.11217 32.0045 20.6085 6.27671 -1.8315 -9147 6 16.2656 6.85278 34.0134 13.6308 -7.44031 -0.955967 -9148 4 16.5278 6.7006 33.1016 -0.686465 1.61317 -6.98637 -9149 4 17.0706 6.57794 34.496 -11.7464 5.49098 9.02554 -9150 6 33.6779 18.1919 10.4599 39.833 -25.9405 -6.08719 -9151 4 34.2274 18.843 9.984 -7.48822 -11.4027 6.26591 -9152 4 34.2403 17.3374 10.5556 -30.6671 44.9369 -7.76686 -9153 6 38.8896 33.7563 36.7672 22.7659 10.9801 -36.8997 -9154 4 38.4264 33.5452 35.9055 8.66825 7.19978 21.2858 -9155 4 39.8358 34.0039 36.5278 -27.7603 -15.0244 3.77145 -9156 6 45.3747 13.0912 20.2115 -8.54575 18.1695 38.2532 -9157 4 45.1986 12.6554 19.3957 -4.2418 -14.8759 -23.2281 -9158 4 44.5273 13.1029 20.6991 7.89471 -4.73094 -13.0554 -9159 6 36.3919 32.2126 8.83938 1.15121 -2.28434 -1.4136 -9160 4 36.3207 31.3933 9.34391 1.93757 3.36082 7.91897 -9161 4 36.0586 32.9456 9.38554 -3.10773 -8.06217 -4.51958 -9162 6 7.93399 27.8164 6.18652 -8.84441 8.26416 -30.5327 -9163 4 8.20753 27.2416 6.88401 9.15323 -7.03573 14.7081 -9164 4 8.30192 28.6748 6.41842 -5.04409 0.971707 0.751098 -9165 6 14.2889 4.87494 33.6812 -48.074 -5.72289 -27.637 -9166 4 13.5426 5.15568 33.0467 38.2298 -5.02982 23.8683 -9167 4 14.8103 5.65434 33.8518 10.0815 16.0504 2.39638 -9168 6 12.247 8.64363 9.86387 9.5307 8.47707 -42.9656 -9169 4 12.7265 8.83196 10.6522 4.83417 -1.95201 32.3898 -9170 4 11.3733 8.28369 10.003 -7.27928 -7.56138 14.4849 -9171 6 29.7193 31.982 8.5339 -11.3757 5.45371 -22.6092 -9172 4 30.2272 31.7973 9.28681 18.5431 -1.21859 37.4341 -9173 4 29.7513 31.1489 8.05875 -9.95983 -0.182644 -6.87416 -9174 6 22.3912 10.8818 21.4749 22.6973 -30.3469 0.856054 -9175 4 21.7953 11.1177 20.7819 -19.5872 13.8984 -18.5017 -9176 4 22.3568 11.5583 22.1363 -13.7305 16.7548 8.89642 -9177 6 54.1825 27.5382 12.9949 16.0749 -34.873 29.2784 -9178 4 0.169556 27.5337 13.075 -9.84187 5.32432 -2.29215 -9179 4 53.8855 28.25 12.4714 -3.97587 36.1158 -26.3516 -9180 6 7.7322 13.8127 20.037 -51.4252 10.19 -38.2554 -9181 4 8.32211 14.101 20.6974 26.6579 16.8549 28.1402 -9182 4 7.28001 14.6396 19.6917 19.816 -24.9044 7.79538 -9183 6 19.8038 0.841082 24.7751 2.23798 25.7663 18.7115 -9184 4 19.2888 0.974936 25.5977 -1.44078 2.26272 -14.328 -9185 4 20.345 1.66892 24.688 -12.1486 -28.8133 2.35345 -9186 6 3.00622 10.0987 2.94957 -26.3714 23.4248 -9.90714 -9187 4 2.57802 10.9845 2.80681 8.85648 -28.8297 5.38 -9188 4 3.90714 10.2978 3.18407 20.8138 3.7803 5.2 -9189 6 15.8735 13.0135 24.0167 27.3456 -6.4848 -7.35342 -9190 4 15.0397 13.4574 24.067 -14.2007 12.8972 1.61729 -9191 4 16.3075 13.2711 24.8409 -0.511489 -7.63656 -0.0548578 -9192 6 17.0843 4.34635 26.9246 21.6007 -4.50946 14.2865 -9193 4 16.8972 4.2188 26.0046 2.50265 0.324122 -20.691 -9194 4 18.0611 4.2338 26.9976 -18.2314 5.96709 -0.11875 -9195 6 33.6189 39.4094 10.6341 -20.462 51.0085 -28.6484 -9196 4 33.9391 38.663 11.0702 20.9333 -51.253 8.17882 -9197 4 33.8334 39.409 9.67256 -1.15733 -4.02232 18.0774 -9198 6 36.2391 1.10544 13.1071 -14.4853 9.25302 -40.2412 -9199 4 35.5849 0.422507 13.2928 -0.138393 -8.38057 10.5121 -9200 4 36.8138 1.26142 13.8363 9.41155 -3.27129 23.8008 -9201 6 40.853 19.2974 5.10856 37.2457 -28.9827 71.4026 -9202 4 40.5429 19.587 4.3016 -40.6732 16.7295 -57.0845 -9203 4 40.1307 19.0416 5.7147 0.644924 10.2678 -10.4268 -9204 6 2.34714 37.5568 10.1845 35.9634 7.02123 17.8242 -9205 4 3.04769 37.1203 10.7322 -14.847 6.26565 -12.1612 -9206 4 1.86424 36.8893 9.71962 -14.8151 -24.6966 -11.8987 -9207 6 8.10127 29.0413 15.8656 35.302 -29.7249 12.8686 -9208 4 9.00843 28.6191 15.9508 -31.5464 15.4715 -14.0583 -9209 4 8.16404 29.7921 16.4466 -1.11054 13.1495 4.82257 -9210 6 47.3142 26.5199 12.5393 12.6514 34.6971 -22.5506 -9211 4 47.5805 27.2834 11.915 -17.373 -39.4708 28.4474 -9212 4 47.3752 25.7188 12.0092 -0.907674 -0.00416251 -5.94845 -9213 6 33.5917 17.5154 0.659811 -43.6991 -50.8046 22.4668 -9214 4 32.6165 17.4611 0.916402 33.9721 22.4374 -10.1482 -9215 4 33.8023 16.5556 0.790839 15.7196 25.0769 -8.55135 -9216 6 38.9785 15.6005 36.3846 -2.2974 -5.19358 -9.56289 -9217 4 39.1604 14.6481 36.4599 -0.972636 7.263 -3.41001 -9218 4 39.314 15.9159 35.5329 5.29716 -3.31476 -2.44888 -9219 6 34.8185 34.3512 9.36223 6.47638 -43.1481 -28.0847 -9220 4 35.4473 34.9875 9.0418 9.26483 22.2324 -9.2882 -9221 4 34.4241 34.6992 10.1221 -17.9819 29.7233 40.2724 -9222 6 44.963 2.56985 14.7807 31.4374 15.1132 5.36654 -9223 4 44.0324 2.49792 14.9225 -24.9873 -3.38313 6.1219 -9224 4 45.264 3.39221 15.2058 -8.16761 -2.00961 -7.57881 -9225 6 42.6004 38.2794 19.8329 35.0217 22.8895 -33.2683 -9226 4 42.7468 39.1886 19.4383 -9.39889 -30.5105 9.50416 -9227 4 43.174 37.7101 19.2395 -23.2435 10.9907 19.5876 -9228 6 18.6884 26.768 30.2631 -44.5574 -6.69712 -17.565 -9229 4 18.1049 26.7773 29.4546 19.8507 -1.43152 25.0232 -9230 4 19.5658 26.9377 29.9555 24.8572 5.14496 -8.76909 -9231 6 38.8622 37.7231 16.4658 -22.8479 4.5656 13.1257 -9232 4 38.7902 36.7734 16.2818 1.44729 8.74588 -1.32739 -9233 4 39.7766 37.9619 16.5567 26.2519 -3.67716 3.06508 -9234 6 49.2941 9.82087 12.5338 42.2108 35.2088 45.7943 -9235 4 48.9089 9.29765 11.888 -36.0338 -29.0733 -40.4243 -9236 4 48.6148 10.195 13.1058 -6.01968 0.395602 -5.44143 -9237 6 43.2224 7.37144 19.82 -8.13737 3.26926 23.5272 -9238 4 42.5007 7.77471 20.3735 21.5488 -7.79487 -11.5807 -9239 4 44.0862 7.49788 20.2643 -6.92785 0.102081 -4.68832 -9240 6 36.344 38.7219 4.42923 6.60518 -8.27287 -3.54737 -9241 4 36.8681 39.515 4.62823 -9.591 -1.38231 4.53716 -9242 4 35.4251 38.8858 4.67742 1.90858 4.69501 2.45497 -9243 6 27.7906 17.7903 15.1063 3.75124 -7.8529 -14.6222 -9244 4 27.6041 16.8818 14.7764 0.112743 20.8749 5.00331 -9245 4 27.89 17.7299 16.0573 -1.67078 -3.69001 6.73869 -9246 6 18.0934 3.7697 37.3166 -37.4896 -7.94699 -19.9181 -9247 4 18.6099 3.0373 36.9676 7.8944 1.98274 4.30106 -9248 4 18.6508 4.23334 37.9126 25.9725 10.5984 22.5053 -9249 6 7.70643 11.5866 6.5218 3.89219 -35.3855 26.5153 -9250 4 7.81247 12.3986 6.99593 -0.830342 19.7116 4.35361 -9251 4 7.69429 11.7375 5.59555 -1.18048 8.56411 -33.1609 -9252 6 31.493 14.3493 18.0362 -8.33789 -14.4781 24.6772 -9253 4 32.1359 14.6991 17.4236 11.1505 2.18599 -11.6706 -9254 4 31.9992 13.8221 18.6877 -1.72215 8.99473 -5.41338 -9255 6 50.3257 30.4119 8.91981 13.6638 2.66477 0.921327 -9256 4 49.6699 30.7962 8.33415 -6.09837 5.9585 -1.44957 -9257 4 50.0726 29.5063 9.09532 -3.6785 -2.74239 1.52637 -9258 6 42.1666 10.1001 12.7665 27.8846 0.568566 -7.78474 -9259 4 41.2574 9.89168 12.6212 -25.0269 -7.71108 -1.23548 -9260 4 42.2044 10.927 13.2385 -4.76175 6.29789 8.61568 -9261 6 37.7726 3.10257 32.5651 17.7286 -33.908 -11.3576 -9262 4 38.1655 3.96622 32.6549 -5.80606 19.6252 0.391082 -9263 4 36.8286 3.11418 32.7073 -14.5698 15.7581 5.48125 -9264 6 35.7529 13.1025 19.269 15.6222 -22.7979 5.95892 -9265 4 36.108 13.8438 19.7616 3.89933 6.86159 4.70877 -9266 4 36.3275 12.3403 19.5267 -16.9537 12.3267 -5.61016 -9267 6 45.5307 4.12701 21.4866 3.53751 -14.4086 10.8893 -9268 4 45.552 4.15257 20.5178 1.20389 1.85135 1.62688 -9269 4 45.7304 3.20168 21.7391 -1.66454 15.9633 -13.005 -9270 6 16.8818 1.84763 31.4809 -38.7514 34.7723 -17.791 -9271 4 16.1373 2.3559 31.0688 16.7124 -32.2776 -3.52377 -9272 4 16.9707 2.38347 32.2636 22.4894 -8.71684 18.7287 -9273 6 14.088 4.88632 23.5804 12.6338 -46.5447 -4.7054 -9274 4 13.8705 5.7909 23.7155 -14.7558 31.001 11.1078 -9275 4 13.7332 4.31383 24.2952 -4.17517 18.1368 -8.36436 -9276 6 38.3179 33.7515 12.3711 -25.6361 -5.15185 -28.4625 -9277 4 38.1256 32.9508 11.8227 6.04426 17.9062 13.2724 -9278 4 39.1779 33.654 12.756 21.0695 -5.21903 12.1581 -9279 6 35.6902 3.04562 37.6746 -3.39904 8.35156 -7.25132 -9280 4 35.0929 2.54933 38.2324 -5.1037 -10.0227 3.00486 -9281 4 35.8394 3.86187 38.1597 5.81883 9.20211 1.39187 -9282 6 31.3375 37.3986 35.3773 -3.71028 -11.6357 31.0668 -9283 4 32.2621 37.6229 35.4422 12.7398 8.80293 9.59752 -9284 4 31.1956 37.5429 34.4696 -8.56261 0.879722 -41.7472 -9285 6 52.0699 11.7425 14.0188 13.7235 -2.71131 -30.9774 -9286 4 51.8967 11.0942 13.2788 12.7756 18.36 20.3091 -9287 4 52.777 12.3878 13.7226 -29.9657 -23.6346 9.26958 -9288 6 26.3494 3.44143 41.0133 25.155 -37.875 16.6614 -9289 4 25.5593 3.94137 41.1232 -17.1598 23.2709 -17.7277 -9290 4 26.8278 3.58917 40.1822 -8.59815 12.7626 -4.44352 -9291 6 24.371 34.9599 11.1571 26.4033 32.6711 -2.50587 -9292 4 24.3639 34.5741 12.011 0.42503 -6.32387 38.1824 -9293 4 23.9976 34.2869 10.6415 -25.866 -31.4028 -29.8537 -9294 6 32.0031 7.59722 31.2247 -0.72006 7.33901 18.8157 -9295 4 32.1508 7.36357 30.327 0.345644 0.817488 -27.7554 -9296 4 31.6126 8.48818 31.2118 -2.13527 -8.40442 2.30992 -9297 6 28.7291 2.6069 0.424694 -24.9548 -1.7826 -18.2237 -9298 4 29.2265 2.34055 41.548 2.55638 3.32464 9.52498 -9299 4 27.7798 2.59721 0.142899 25.7986 3.33204 9.63582 -9300 6 42.1267 19.2107 9.86358 19.9254 -1.00598 31.807 -9301 4 42.7282 19.2504 10.675 -28.0191 -3.63038 -32.4782 -9302 4 41.4654 18.506 9.99331 2.41107 5.70909 -2.24499 -9303 6 33.0117 27.0899 8.33041 6.96541 -9.8522 -22.9567 -9304 4 33.8754 26.9804 7.88875 -4.89246 2.6856 6.68054 -9305 4 33.1889 27.2976 9.23992 7.88062 7.04275 14.0068 -9306 6 4.17016 8.31297 19.162 0.312608 -23.727 -31.8356 -9307 4 4.57057 7.90515 18.3575 7.98956 13.418 22.158 -9308 4 3.24181 8.25888 18.9046 -6.31749 7.79174 9.16769 -9309 6 20.797 29.1851 37.0682 -78.8245 -16.0462 -5.4556 -9310 4 20.936 28.2326 36.9784 16.4861 -0.723813 3.66436 -9311 4 21.5674 29.6886 37.0761 54.0195 18.5923 4.39527 -9312 6 13.113 4.99943 10.9253 0.843453 12.9862 -7.21248 -9313 4 13.3812 5.91092 11.1622 0.48683 -16.0572 0.936043 -9314 4 12.7752 5.03128 10.0238 -4.21215 6.55392 -0.64752 -9315 6 37.5015 18.1018 32.5195 21.2703 25.6519 14.9603 -9316 4 38.1786 18.7738 32.2234 -25.3038 -17.5123 8.13315 -9317 4 37.1867 18.4103 33.3985 6.70568 -0.056708 -13.7279 -9318 6 17.7491 33.2689 30.7387 4.64458 14.8517 -20.1826 -9319 4 17.8421 33.9996 30.1068 1.39741 -2.79987 6.34018 -9320 4 18.5541 33.2627 31.2599 6.50121 5.74528 2.59283 -9321 6 23.1871 32.777 9.90494 7.13269 10.4795 -4.3903 -9322 4 23.4604 31.94 10.2921 1.41378 -5.3263 0.807867 -9323 4 22.2339 32.7251 9.74224 0.938735 -0.283076 -0.953242 -9324 6 14.8916 9.36878 34.2544 -3.17606 -9.25219 -4.09189 -9325 4 15.4257 8.57154 34.1751 4.23415 -4.52565 -0.814207 -9326 4 15.1936 9.94604 33.5417 3.33837 13.7034 4.88209 -9327 6 31.123 39.3556 38.5725 10.4581 -15.7875 9.507 -9328 4 31.6408 38.6334 39.0195 -17.0405 19.4438 -10.5616 -9329 4 30.3963 38.9123 38.1137 2.26745 0.847431 0.999129 -9330 6 5.28935 34.441 28.2777 -1.85934 -10.7383 -20.8922 -9331 4 5.27738 35.3973 28.3959 -1.64374 -0.931958 4.82044 -9332 4 5.15855 34.3195 27.3212 3.56171 0.206479 13.9304 -9333 6 30.3161 21.6889 14.1169 -2.08187 28.5408 26.4102 -9334 4 30.4824 20.7856 14.3415 3.20532 -20.0191 -7.60805 -9335 4 30.3589 21.8902 13.1869 1.55029 -10.1196 -17.5522 -9336 6 23.85 39.0046 28.2977 69.4329 26.2515 4.57453 -9337 4 23.9916 39.6084 27.5499 -13.57 2.08121 2.63988 -9338 4 23.036 38.5875 28.2612 -60.5143 -23.8938 -11.8576 -9339 6 9.59742 13.5396 16.4589 33.261 19.9292 -8.86772 -9340 4 8.78625 13.0496 16.3926 -14.9619 -4.96746 -5.567 -9341 4 9.78335 13.9533 15.5888 -9.09133 -14.4247 9.50074 -9342 6 25.9705 6.17968 15.7985 42.799 -23.1477 28.9675 -9343 4 26.019 6.01901 14.8637 -2.75181 4.35539 -17.3872 -9344 4 26.7603 5.64791 16.135 -36.9143 25.7793 -10.0513 -9345 6 15.9952 33.6108 22.5498 -1.32684 21.179 0.174096 -9346 4 16.0845 34.132 21.7265 -5.08009 -17.3545 9.33233 -9347 4 16.0452 32.6693 22.2946 2.44519 21.8582 -2.86748 -9348 6 40.6954 13.5457 12.1293 -5.68603 3.79069 10.9638 -9349 4 40.3939 13.0592 11.3555 -1.07855 -14.0058 -3.54454 -9350 4 41.0539 12.9031 12.7626 -3.06611 3.62129 -5.67307 -9351 6 35.5822 40.2773 31.6862 -1.2862 -13.706 14.6905 -9352 4 36.0451 40.9783 31.2154 -1.32327 -4.34646 -14.1397 -9353 4 35.653 39.3915 31.2603 0.648621 22.1552 -3.29488 -9354 6 19.3539 17.5757 17.8527 24.8545 64.4629 -5.36553 -9355 4 19.9703 18.4106 17.9379 -31.776 -45.1138 0.798127 -9356 4 18.7059 17.8424 17.1823 2.41282 -7.28307 3.58563 -9357 6 7.95249 28.0742 10.7793 26.3782 25.043 4.49745 -9358 4 8.50313 28.8396 11.0908 -15.1612 -19.5627 1.83511 -9359 4 7.20779 28.4792 10.322 -5.34026 -2.34355 -4.06419 -9360 6 32.1473 39.5951 16.6478 -17.9563 1.55165 -8.91142 -9361 4 31.6569 40.3908 16.3404 14.2892 -12.9666 6.03874 -9362 4 31.5266 38.8716 16.4637 6.06753 4.48602 8.64925 -9363 6 35.7883 2.63292 18.1275 9.48574 -34.9606 14.0071 -9364 4 34.8666 2.32593 18.1793 13.7366 6.70894 -2.41967 -9365 4 35.7792 3.51083 17.8116 -6.62646 29.9084 -15.3578 -9366 6 14.9404 39.9496 36.887 -3.95865 -34.2615 35.0372 -9367 4 15.4649 39.4425 36.2826 11.0028 -6.45738 -16.6057 -9368 4 15.0284 40.8419 36.6608 5.56286 51.7396 -15.8162 -9369 6 18.3052 32.4025 11.469 7.68428 8.43447 19.219 -9370 4 18.6311 32.5236 12.4045 -8.3236 -1.07971 -30.5152 -9371 4 17.8613 33.2392 11.223 7.02035 -14.738 0.639166 -9372 6 14.6021 10.381 5.00501 12.904 -5.64335 9.41677 -9373 4 13.6938 10.4305 4.69945 -10.3065 0.63937 1.1744 -9374 4 14.613 10.0418 5.92181 -1.23128 6.20644 -15.3767 -9375 6 2.02771 14.3355 39.1727 -5.84559 30.0988 4.34298 -9376 4 2.70173 15.0418 39.0898 -4.78946 -14.8923 5.30178 -9377 4 1.28797 14.7602 39.6738 10.0694 -17.377 -15.1558 -9378 6 7.58332 14.1556 32.4652 3.8824 27.7869 10.7592 -9379 4 6.9433 13.665 32.9756 -4.43494 -6.18284 1.69377 -9380 4 7.54129 15.0698 32.8492 6.23928 -24.1467 -15.6449 -9381 6 6.15722 23.1341 37.6504 -34.5618 -50.1938 -2.0692 -9382 4 6.56488 23.96 37.7745 13.4151 41.4847 -0.267706 -9383 4 5.38195 23.2242 37.0516 20.9526 5.02196 8.70483 -9384 6 37.2952 22.537 4.44472 51.3933 75.9823 3.75371 -9385 4 36.5074 22.1342 4.18978 -47.7056 -22.8011 -17.3868 -9386 4 37.221 23.5361 4.21623 -3.53185 -51.7458 12.1203 -9387 6 47.1368 31.0168 5.89375 -14.3926 17.1884 -69.1718 -9388 4 46.9718 30.7968 6.77028 -10.6218 -7.91998 56.0799 -9389 4 46.2684 31.351 5.53353 23.0456 -16.9797 4.17914 -9390 6 54.8109 25.5937 34.9376 16.0179 27.3393 -6.0446 -9391 4 54.0726 25.4665 35.5517 -1.08617 7.29827 -2.61058 -9392 4 0.161491 26.54 35.0366 -21.9365 -36.0956 3.57937 -9393 6 37.1499 2.07739 4.80452 -1.94348 22.0087 -45.3652 -9394 4 36.668 2.89852 4.54683 5.06511 -19.4283 11.9563 -9395 4 37.1062 1.96831 5.73813 -4.74438 -1.19387 27.2393 -9396 6 22.5142 28.609 8.91066 14.7838 -0.767913 33.3492 -9397 4 22.9803 28.3541 9.73828 -15.565 12.7605 -7.61321 -9398 4 22.8168 27.9481 8.31925 3.93055 -13.9923 -25.0246 -9399 6 8.64284 27.1533 24.5627 -30.3364 66.7798 9.61681 -9400 4 7.68564 27.0552 24.6389 4.16714 -15.7471 -5.05425 -9401 4 9.10482 26.3676 24.4825 22.9633 -64.4218 -6.53839 -9402 6 1.14841 23.7276 2.43845 3.37143 2.75553 -28.3576 -9403 4 1.24451 23.8913 1.47114 -2.40676 3.6179 20.3541 -9404 4 0.297784 23.2877 2.48462 -2.13531 -2.42607 6.29474 -9405 6 54.3749 30.2279 27.0351 -1.87188 5.01086 -25.6864 -9406 4 54.247 29.4439 26.4851 0.283672 1.58093 2.67322 -9407 4 54.589 30.9178 26.3677 -1.31459 -2.18642 16.2549 -9408 6 0.382292 8.43516 23.9819 16.8945 -11.9539 9.7221 -9409 4 1.32445 8.60369 24.1565 -2.20413 -11.2301 -8.89161 -9410 4 54.9553 8.73001 24.7921 -9.77823 11.7559 2.768 -9411 6 16.9131 28.5848 33.3683 -2.23593 -25.3201 -21.0962 -9412 4 17.3654 28.7863 34.1955 9.02781 -2.88055 -0.915496 -9413 4 17.3951 27.8627 32.8656 -13.2947 27.9561 26.4245 -9414 6 33.6945 30.8881 0.140848 11.5734 5.16226 7.65985 -9415 4 34.5903 30.4955 0.196618 -6.50407 7.83028 -3.90982 -9416 4 33.2725 30.4522 41.313 0.902851 -8.5209 -4.03004 -9417 6 16.2572 21.5133 34.1618 -1.32279 -12.2579 -0.0768877 -9418 4 15.8666 20.7686 33.6578 14.5936 10.7995 5.0381 -9419 4 16.7742 21.1109 34.8905 -13.5083 8.43335 -11.1581 -9420 6 0.208862 17.804 35.7536 -14.601 -29.9007 -2.72034 -9421 4 54.2286 17.807 35.5323 33.4083 9.0609 14.8615 -9422 4 0.362977 16.9429 36.1939 -0.60553 13.4006 -6.21859 -9423 6 16.8205 12.2987 0.018055 22.2965 10.2312 29.8095 -9424 4 17.2696 12.8062 0.753963 -11.4311 -8.71934 -28.0399 -9425 4 16.617 11.4478 0.422257 -11.1364 1.3302 -4.58262 -9426 6 8.24969 9.53941 36.253 -15.0171 13.8578 -6.15226 -9427 4 7.92627 8.96163 36.9484 -10.0154 -4.61382 -0.313479 -9428 4 7.46687 9.9886 35.83 14.4541 -3.15884 14.1629 -9429 6 48.5699 26.7153 39.8372 -6.05787 -6.72914 15.0837 -9430 4 48.3449 26.8926 38.9385 -16.4424 3.29077 -18.6566 -9431 4 49.4571 27.0352 39.8842 23.4859 3.73228 5.76721 -9432 6 35.4844 1.07048 23.1169 11.4549 30.8088 37.1655 -9433 4 36.0158 1.76714 22.6808 -9.17201 -14.7916 0.90361 -9434 4 35.6328 1.27141 24.1103 0.373025 -19.0496 -44.6811 -9435 6 20.2784 30.6315 19.3752 23.9103 -21.6662 15.3888 -9436 4 20.3116 31.0532 20.259 -5.42732 -3.95571 -8.57186 -9437 4 20.9344 29.8759 19.4191 -22.0709 25.9102 -5.54449 -9438 6 44.3706 15.9499 1.58551 5.68582 14.4456 12.9619 -9439 4 44.3685 15.5676 2.49167 2.87795 14.7015 -16.764 -9440 4 44.6274 16.9163 1.6094 -6.5628 -31.3198 6.45039 -9441 6 53.8881 34.4681 10.5864 -33.0496 11.7448 -26.9592 -9442 4 54.422 34.2751 11.3149 32.4161 -9.35278 40.7994 -9443 4 54.2788 35.2396 10.1584 -0.0979649 -6.0993 2.73708 -9444 6 46.1388 32.8516 33.5211 5.22207 -15.0187 3.22626 -9445 4 45.9452 33.6327 33.0044 -1.75723 11.2428 -3.91525 -9446 4 47.0422 32.5752 33.2841 -5.1447 4.42718 0.252344 -9447 6 42.1248 21.9061 24.225 29.3467 -8.59285 14.1471 -9448 4 43.0897 21.6191 24.2618 -39.2895 4.06832 7.69751 -9449 4 41.7308 21.6944 25.1042 13.707 1.91177 -18.5137 -9450 6 8.13464 3.90485 11.6471 19.3767 -1.70453 -18.8264 -9451 4 7.33962 4.19894 12.0861 -8.05938 -6.79837 10.6821 -9452 4 8.35918 3.01511 11.9412 -4.68297 1.80025 9.46807 -9453 6 19.6422 41.6776 9.83213 -10.6455 12.1827 13.5714 -9454 4 18.8651 41.1405 9.66265 4.99962 -3.76564 -7.41899 -9455 4 19.3487 0.264237 10.6212 9.02518 -11.5641 -14.6522 -9456 6 42.3073 8.42404 31.6799 28.9247 6.2763 -10.2166 -9457 4 41.4386 8.38933 32.0551 -18.7028 2.48038 0.978172 -9458 4 42.5266 9.37939 31.5704 -3.99861 -19.3235 1.7837 -9459 6 26.9144 16.155 25.3557 3.37886 4.46922 -29.1574 -9460 4 26.8932 15.8089 24.4276 -4.09623 14.1183 21.5023 -9461 4 26.5944 15.4425 25.8888 -2.2842 -17.5105 15.3426 -9462 6 48.2339 6.48607 12.6213 -2.32796 -4.32122 -9.13051 -9463 4 48.9884 6.29985 12.0375 -6.36801 1.93824 2.64233 -9464 4 47.4521 6.15437 12.1363 8.14441 0.739204 7.03502 -9465 6 53.4551 41.5313 30.6545 -6.55363 -20.9747 -16.7061 -9466 4 53.9707 41.8328 29.895 1.38615 3.54438 2.31965 -9467 4 53.5938 0.199493 31.3858 11.9182 14.0856 15.8016 -9468 6 47.0766 22.4304 31.8083 3.49024 11.2606 -9.33253 -9469 4 47.8957 22.458 31.249 -27.0486 7.80914 13.6686 -9470 4 46.5597 23.2507 31.6033 14.3992 -20.3875 6.89099 -9471 6 19.5103 5.43818 15.252 80.4346 7.77941 -36.259 -9472 4 19.9845 4.58151 15.2093 -6.94904 10.3389 3.32724 -9473 4 18.6939 5.26573 15.6196 -64.0069 -9.45641 27.6942 -9474 6 14.6723 30.2358 33.3977 29.3194 14.0021 -15.573 -9475 4 15.2147 30.9127 32.9173 -16.9191 -15.4944 5.99358 -9476 4 15.2716 29.4658 33.3729 -9.39086 7.05787 2.01807 -9477 6 28.44 24.2314 10.4028 3.15123 -12.4056 -9.54268 -9478 4 29.226 24.4262 10.8786 32.4584 2.85658 2.79411 -9479 4 27.8296 24.5485 11.0342 -36.3144 6.15546 12.0187 -9480 6 5.27118 14.4387 24.4945 35.1445 25.2092 -0.0633509 -9481 4 4.43594 14.1516 24.7736 -48.8682 -19.2375 4.52664 -9482 4 5.4685 14.0235 23.6561 -3.04719 -11.4521 -9.99341 -9483 6 26.3524 19.2908 19.1818 20.1263 -20.0506 -24.4735 -9484 4 26.6388 20.1349 19.5116 -1.98461 18.5008 5.62334 -9485 4 27.0961 18.9592 18.5977 -26.1102 9.18548 27.2368 -9486 6 28.5758 7.44193 13.1857 16.8206 36.5977 2.40675 -9487 4 28.4276 6.5743 12.8854 -8.83608 -34.241 -6.14436 -9488 4 29.1296 7.84613 12.4994 -7.23682 2.38597 3.89632 -9489 6 5.36882 27.1473 37.046 11.8823 -4.88323 19.1587 -9490 4 6.08575 26.9595 37.7076 -19.1456 -1.45009 -21.6041 -9491 4 5.36685 28.0942 36.8598 5.86896 -0.355799 -4.60773 -9492 6 53.1378 13.4025 16.0996 34.2435 -3.86055 5.06914 -9493 4 54.0829 13.0966 15.9504 -32.0077 5.91706 2.7318 -9494 4 52.5847 12.6783 16.4422 5.4814 -0.344951 -11.4066 -9495 6 45.452 1.01889 24.6154 3.31322 11.7394 9.54943 -9496 4 44.8157 0.989703 23.8982 -3.33354 -4.25493 -1.52857 -9497 4 44.9019 0.844105 25.4008 9.82267 -2.51687 -6.81685 -9498 6 50.1641 2.37547 13.9256 -5.79196 7.9049 4.59273 -9499 4 50.7992 2.78767 13.3238 -3.84891 -0.754592 0.637936 -9500 4 49.4746 3.0334 14.0873 2.34893 4.7321 -2.13859 -9501 6 19.5803 31.0161 39.1628 -18.0613 -25.9328 -11.5794 -9502 4 19.7424 30.2951 38.4816 -0.347779 24.7736 22.083 -9503 4 18.6224 30.9377 39.4182 28.2801 4.19594 -11.375 -9504 6 19.2561 14.7051 10.8744 35.9018 -50.5273 5.13524 -9505 4 20.0412 14.097 10.5737 -45.0165 49.548 5.48727 -9506 4 18.7602 14.0269 11.3662 -4.16951 16.5755 -2.6658 -9507 6 4.45594 39.5485 20.1375 -7.26247 21.8372 28.3356 -9508 4 3.95576 40.4005 20.2782 15.6699 -22.2203 -5.74536 -9509 4 4.87483 39.3065 21.0019 -15.4768 4.14169 -24.4646 -9510 6 29.0152 13.3442 23.91 8.01267 35.4951 15.4816 -9511 4 28.7225 12.4574 23.7464 -4.82052 -12.6612 5.31893 -9512 4 28.8407 13.5397 24.8723 9.679 -4.85246 -32.6651 -9513 6 17.068 2.76349 17.6602 17.5731 -10.7754 -19.6116 -9514 4 16.9152 3.43747 16.9733 0.569879 -2.90947 3.06519 -9515 4 17.8166 2.20316 17.3149 -21.6663 12.1671 7.12297 -9516 6 43.4725 18.0406 17.7144 -1.44781 -24.3706 15.3127 -9517 4 43.4291 17.0524 17.7495 6.1749 24.1268 -14.107 -9518 4 43.576 18.2305 18.6573 0.474252 7.4982 -2.94392 -9519 6 25.7765 40.7491 1.25834 -5.13784 -8.67992 -41.8469 -9520 4 26.3241 41.1434 1.92597 2.9618 17.1891 5.50682 -9521 4 25.7331 41.3641 0.469204 -4.81559 -13.5206 29.0343 -9522 6 0.465549 22.8917 6.22214 -2.55797 -7.94984 -3.9446 -9523 4 0.971697 22.1453 5.8424 -8.20264 3.34524 4.91565 -9524 4 1.09943 23.372 6.75946 4.60597 5.6548 -4.31438 -9525 6 26.241 35.011 18.6432 -1.36099 17.7753 -9.20742 -9526 4 25.9471 35.9461 18.6768 6.76043 -15.7179 -8.96745 -9527 4 25.6107 34.5957 19.2286 4.79325 -10.2415 3.05652 -9528 6 16.134 31.8742 7.55305 63.3701 -24.5537 -22.1036 -9529 4 16.96 31.3344 7.22221 -43.8871 18.402 28.1533 -9530 4 16.2567 32.6659 7.02685 -6.92396 6.43503 -6.66113 -9531 6 22.9365 16.8424 28.5556 -11.8911 28.7995 -6.03551 -9532 4 23.1131 16.1224 27.957 -2.92592 -13.6094 -7.1053 -9533 4 22.1672 17.3806 28.2048 22.5292 -24.3034 15.5849 -9534 6 48.8154 29.3426 32.1508 17.6607 -5.63259 25.101 -9535 4 47.9338 29.1776 31.8283 -15.752 -0.354552 -3.67809 -9536 4 48.876 28.9209 33.0523 -3.3832 13.4569 -22.7771 -9537 6 13.1275 24.861 5.55911 -24.9858 12.0714 -24.023 -9538 4 12.9095 24.1076 4.98414 3.68764 2.77663 3.09454 -9539 4 12.4428 25.5491 5.3163 19.4298 -17.0083 16.84 -9540 6 10.97 20.7168 15.838 25.2219 -21.2413 -18.4662 -9541 4 10.9273 20.4774 14.8836 -9.78471 10.8905 20.232 -9542 4 11.8407 20.3068 16.0784 -25.4832 11.5027 -0.03881 -9543 6 13.8668 18.3675 6.9377 -17.1805 34.1284 -15.5183 -9544 4 13.9861 19.3268 7.07801 0.95534 -8.68107 -9.41428 -9545 4 14.2312 17.9937 7.71618 14.696 -22.4056 21.3209 -9546 6 13.8328 12.9436 30.6366 23.8936 8.4875 1.93436 -9547 4 14.0561 12.5213 29.7889 -15.7862 -10.4805 9.2002 -9548 4 13.0857 12.5134 31.0734 -5.46762 -5.09599 -12.1481 -9549 6 17.1276 6.33232 31.2677 66.6528 76.8842 26.6004 -9550 4 16.7194 7.19542 31.0916 2.25558 -4.54354 -1.53399 -9551 4 16.4872 5.75051 31.0533 -74.7845 -70.3194 -26.0669 -9552 6 7.63688 23.4278 20.549 2.87884 3.81634 -6.68902 -9553 4 7.34623 23.1229 19.6666 2.94756 -0.449201 10.6329 -9554 4 8.04096 24.3016 20.3852 -3.87648 -11.4978 -1.95405 -9555 6 15.5875 36.6622 25.6317 44.8659 35.0544 -6.16252 -9556 4 16.5723 36.6215 25.7443 -25.3852 -14.6967 7.558 -9557 4 15.5456 37.5452 25.2115 -8.92727 -11.7797 -1.50769 -9558 6 0.738994 10.4213 22.1809 -27.1543 -36.2471 -13.1925 -9559 4 0.031346 10.3136 21.4752 22.4259 7.4169 21.1377 -9560 4 0.614162 9.62536 22.7539 0.837437 23.266 -16.3015 -9561 6 33.4753 17.3986 33.5966 50.0322 34.9653 -25.691 -9562 4 33.729 18.3684 33.3861 -23.79 -42.9591 12.1009 -9563 4 34.1104 16.8695 33.0603 -9.99519 5.32569 13.787 -9564 6 21.6594 19.0069 20.7632 22.9673 -17.6764 -6.78691 -9565 4 22.3468 19.6741 20.9606 -3.94962 -13.1079 -1.95693 -9566 4 22.1476 18.14 20.6003 -16.6978 33.0759 6.74927 -9567 6 41.7633 20.003 16.8748 -11.326 -1.31128 -8.84591 -9568 4 42.2034 19.1563 16.9874 6.48398 -7.2756 0.328325 -9569 4 41.4682 20.0367 15.9399 8.87316 5.12137 10.7952 -9570 6 12.0358 14.9766 17.6999 -26.21 -7.2152 -26.0517 -9571 4 11.2991 14.5498 17.1995 11.2858 13.8526 14.1879 -9572 4 12.4764 14.2447 18.105 9.10187 -13.3837 13.9354 -9573 6 23.0147 11.4211 40.7142 -19.9953 11.3897 74.5259 -9574 4 22.9359 12.2968 41.1901 4.60696 -23.5555 -21.1396 -9575 4 23.3157 11.5565 39.857 19.7433 14.0142 -51.5111 -9576 6 21.0056 28.3023 24.5803 -69.1041 85.2373 -40.9106 -9577 4 20.265 28.1264 25.1705 5.37048 -3.26467 3.49678 -9578 4 21.6928 27.7549 24.7451 59.1792 -66.0576 27.8401 -9579 6 19.39 13.7159 31.9239 29.4118 -13.0288 15.1298 -9580 4 18.7661 13.9847 31.2678 -13.3276 3.02657 -9.68553 -9581 4 18.8827 13.5849 32.728 -3.24577 4.6437 7.00982 -9582 6 21.5915 2.84466 24.7134 0.208747 24.5944 -29.04 -9583 4 21.6872 3.18692 23.7998 -4.92058 -5.74628 13.5023 -9584 4 22.4885 2.58061 24.905 3.18231 -12.543 15.1704 -9585 6 11.3458 29.9955 18.8336 12.03 22.8495 18.6886 -9586 4 10.5716 30.5896 18.8018 6.29595 -15.7791 -4.99952 -9587 4 11.9743 30.476 19.4324 -17.0963 -23.9187 -22.0967 -9588 6 14.6495 22.3648 8.3568 42.8177 1.00499 7.23029 -9589 4 14.0031 23.0587 8.53935 2.83958 6.20927 5.13977 -9590 4 15.5993 22.7606 8.33857 -60.0645 -13.0658 0.526795 -9591 6 43.9468 23.6541 17.2812 -2.43742 26.8438 -12.7514 -9592 4 44.7651 23.2701 16.9945 19.1668 -3.91001 -9.18188 -9593 4 43.5028 22.9 17.6346 -11.2125 -8.13016 15.2757 -9594 6 28.0047 25.4978 27.5091 9.49546 -35.4414 -7.32855 -9595 4 27.536 26.3032 27.53 -22.6173 33.7003 2.08289 -9596 4 28.9082 25.7508 27.3241 10.2254 5.98924 0.98151 -9597 6 19.1021 26.8113 33.1456 6.96794 1.44941 -44.6281 -9598 4 19.0009 26.3889 32.2316 6.61058 22.4795 36.193 -9599 4 19.4537 27.7357 32.9996 -8.5054 -25.835 6.12407 -9600 6 6.37601 19.3499 5.67113 -3.07724 -15.511 8.20386 -9601 4 6.68786 20.0294 5.07731 7.18653 8.65774 -7.7972 -9602 4 5.56195 19.7092 6.03854 -2.87224 2.62267 4.46635 -9603 6 37.49 28.403 9.68405 -10.2736 -31.6176 -26.4717 -9604 4 37.8518 27.9475 10.4351 5.1765 10.0485 19.5132 -9605 4 37.3493 27.6251 9.09625 -2.69325 25.3221 7.01666 -9606 6 17.6998 27.0953 11.7898 -36.7906 -34.4972 13.5582 -9607 4 17.0141 26.488 11.3694 25.6316 27.0728 3.78529 -9608 4 17.4298 27.07 12.7376 6.94557 14.4563 -18.9236 -9609 6 12.8888 1.93962 24.1529 -50.3802 38.9184 -15.728 -9610 4 12.0235 2.45928 24.1313 32.0413 -19.6529 -17.3906 -9611 4 12.9222 1.7892 25.0724 13.055 -19.4335 33.1456 -9612 6 27.8476 37.1183 33.3015 17.2618 -5.56645 -20.6455 -9613 4 27.8725 37.7306 32.5366 -3.66202 -8.07766 15.1749 -9614 4 28.4268 36.3488 33.0405 -13.8477 22.6944 8.61763 -9615 6 18.6736 12.3707 6.31908 6.91225 -31.4632 27.4828 -9616 4 18.6995 11.385 6.25383 -9.67628 20.7874 -2.26223 -9617 4 18.5836 12.6888 5.4344 -4.12511 6.2973 -26.1687 -9618 6 10.1784 29.305 24.7735 -9.10204 -23.9111 21.4033 -9619 4 10.6991 28.9855 25.5395 2.35147 16.2142 -6.30056 -9620 4 9.48939 28.598 24.7147 15.6456 22.7499 -9.47694 -9621 6 7.25796 3.28933 16.2737 -3.06701 21.6066 -7.53298 -9622 4 7.8017 4.02386 16.6541 -5.18893 -18.6288 5.77884 -9623 4 6.83195 2.7267 16.9458 19.6595 6.39335 -0.783342 -9624 6 32.1965 37.5589 1.11244 17.7564 -13.393 -49.4834 -9625 4 31.8113 36.9118 1.6863 -14.8068 -2.94474 23.9511 -9626 4 32.3136 38.4192 1.49585 -8.3749 16.0852 25.1081 -9627 6 10.4319 10.1504 6.4166 -7.63199 8.14139 10.6713 -9628 4 9.50403 10.3698 6.52583 -9.38347 6.87647 -8.77798 -9629 4 10.8186 10.5343 7.22249 5.92406 -9.68277 -8.25616 -9630 6 16.1813 23.2506 37.3799 25.1097 11.6639 -4.85114 -9631 4 16.5396 23.4181 38.2693 -7.5274 5.30939 -3.10176 -9632 4 16.7237 23.8262 36.781 -18.6662 -9.83464 11.0165 -9633 6 24.0859 14.3313 36.5421 -9.86516 7.30801 -0.382215 -9634 4 25.0278 14.1902 36.5644 12.4097 -8.07045 3.76472 -9635 4 23.7255 13.9571 37.3615 2.98939 6.5027 1.55174 -9636 6 27.4763 18.5532 28.7891 -13.5271 -4.91773 7.22809 -9637 4 27.279 18.1935 29.6763 -0.617381 3.48163 -16.8994 -9638 4 26.6639 18.4733 28.2428 3.34183 3.33207 10.806 -9639 6 51.5601 10.4909 1.56577 -57.9967 -14.5533 -18.7957 -9640 4 50.8004 9.99697 1.98849 19.2905 21.9947 -18.6033 -9641 4 52.233 10.462 2.20044 35.6887 -2.31897 35.1783 -9642 6 31.1159 39.6224 27.5035 10.1927 26.9633 6.19817 -9643 4 30.6636 39.3812 28.2975 -12.6206 -22.2416 8.82104 -9644 4 31.2642 40.5609 27.7597 6.49383 -23.2522 -24.0775 -9645 6 6.91312 35.9708 14.3252 -31.0555 -15.8542 22.3873 -9646 4 7.60399 36.2341 13.7609 26.7748 16.1612 -20.4248 -9647 4 7.14109 35.0698 14.5861 -2.88708 -0.858877 1.78829 -9648 6 45.5543 7.568 29.1737 -25.5302 -4.16762 -2.13202 -9649 4 44.8976 7.53234 28.4293 19.2773 0.699039 20.3251 -9650 4 45.0852 7.16669 29.9393 6.23602 2.26061 -10.7804 -9651 6 31.3622 20.562 31.6184 9.65463 4.63597 0.319717 -9652 4 31.8498 21.4034 31.7895 1.14978 -23.5084 -11.6884 -9653 4 31.8627 19.9392 31.0494 0.180852 16.2895 10.8054 -9654 6 43.0328 31.1512 10.3804 -22.1718 15.2565 33.5805 -9655 4 42.075 30.8844 10.4741 26.7443 4.92622 -3.29861 -9656 4 43.2631 31.5811 11.2548 -4.68507 -19.1463 -31.4268 -9657 6 50.935 25.5526 12.6381 -53.0362 -11.2381 37.5759 -9658 4 50.8444 26.3707 12.1889 6.26198 32.0523 -21.5557 -9659 4 51.7606 25.1556 12.4927 46.8244 -9.35474 -8.90879 -9660 6 29.329 2.97736 3.64421 22.5456 -43.1143 -6.52899 -9661 4 29.5843 3.84773 3.82541 15.3974 46.6652 11.4603 -9662 4 28.3975 3.01514 3.57252 -35.3193 1.84796 -10.7817 -9663 6 53.9306 32.0952 20.3602 -26.044 3.42844 6.98601 -9664 4 54.8587 32.2554 20.2589 13.6369 -3.90514 -8.57062 -9665 4 53.586 31.7345 19.5218 3.48091 2.50952 8.05406 -9666 6 41.7156 29.5544 6.48768 19.5894 27.0766 -19.1548 -9667 4 40.8143 29.536 6.19581 -21.1406 0.0261655 0.681639 -9668 4 42.121 30.2839 5.93213 -7.9284 -21.0777 21.5612 -9669 6 37.8354 24.5725 39.3073 -0.786614 -2.83003 -8.48557 -9670 4 37.3057 24.1981 38.5867 -0.305281 2.91934 11.1175 -9671 4 37.4479 24.2715 40.1417 -1.64355 1.86967 -5.36783 -9672 6 46.558 27.5785 23.289 -39.9634 -64.6481 11.0379 -9673 4 46.4646 27.3918 24.2576 6.74558 16.0433 -18.2165 -9674 4 45.9199 26.8188 22.9475 37.5572 46.869 6.09964 -9675 6 9.22773 27.2022 8.33468 -36.26 12.7871 28.7267 -9676 4 8.91275 27.6129 9.1801 5.62558 -9.89589 -23.2096 -9677 4 10.1414 27.0456 8.46037 35.2783 -3.07459 2.5747 -9678 6 36.0491 34.1608 13.9867 7.26402 -14.0442 8.68546 -9679 4 35.9913 33.1738 14.0461 -7.39622 22.1346 -4.41017 -9680 4 36.7548 34.3393 13.3524 -0.0889916 -4.95725 -2.25698 -9681 6 51.6742 14.4867 12.321 25.1613 25.5512 -24.4042 -9682 4 52.0989 14.4284 11.4335 -6.19684 -3.38259 22.4379 -9683 4 51.9807 15.3554 12.6493 -12.3863 -19.4348 1.31199 -9684 6 15.2583 19.6409 32.4144 29.0083 -20.2623 -33.8133 -9685 4 15.2558 19.2688 31.4922 3.04968 7.12699 22.6875 -9686 4 14.3622 19.8256 32.5802 -41.1763 4.86179 8.56209 -9687 6 27.6812 24.6569 38.3606 -19.0318 -31.8029 -32.3422 -9688 4 27.9736 25.1472 39.0974 14.6808 26.4307 29.745 -9689 4 28.3717 24.6185 37.6939 9.13491 6.22605 4.36089 -9690 6 37.5205 9.26898 13.6241 11.458 -4.07639 -2.41324 -9691 4 37.986 8.73412 14.2818 -4.17908 -1.66932 4.91722 -9692 4 37.422 10.1332 14.0472 -5.80925 -1.58022 -1.38856 -9693 6 20.8962 33.2419 26.2614 5.37543 12.855 -2.41316 -9694 4 21.3204 33.4412 27.1125 -5.30181 -3.15861 -4.46659 -9695 4 20.9369 32.3076 26.1263 8.87353 -20.0108 1.20924 -9696 6 6.59104 13.9455 35.2329 -26.8274 -4.60486 4.58094 -9697 4 6.38745 12.9897 35.2457 11.7642 5.99643 -3.17645 -9698 4 7.53507 14.0926 35.2395 12.5421 -8.77428 2.26249 -9699 6 10.0726 7.48467 6.8792 2.12641 6.95589 -11.9404 -9700 4 9.21804 7.15917 6.5645 -4.80657 -1.75614 5.47812 -9701 4 10.1222 8.42177 6.5916 5.16955 -15.159 7.51812 -9702 6 31.1977 5.95154 11.4339 24.7603 28.3677 15.6689 -9703 4 31.4296 6.16733 12.4018 -4.97657 -8.97631 -41.3224 -9704 4 31.9131 6.32779 10.8565 -11.9651 -11.6794 24.5691 -9705 6 12.1328 3.85103 35.2933 -10.0815 -12.0493 27.5499 -9706 4 12.7851 4.21657 34.7189 20.4312 8.87509 -12.0205 -9707 4 12.5123 3.89786 36.1903 -2.36263 6.36147 -16.6701 -9708 6 5.35168 6.07805 27.6549 3.96089 -18.0524 46.6648 -9709 4 5.01336 6.85569 28.0965 2.16186 8.49085 15.9688 -9710 4 5.1377 6.25223 26.7855 -7.5711 11.2001 -66.4514 -9711 6 13.1382 33.574 1.68419 20.6109 34.6607 2.95503 -9712 4 12.5953 33.0967 1.0817 -13.6453 -8.09858 -18.4215 -9713 4 13.3822 34.4502 1.26439 -11.0211 -27.5174 16.1165 -9714 6 44.6427 10.3996 29.0359 8.91116 23.4714 -13.18 -9715 4 44.4953 9.45294 29.0952 0.434286 -4.87704 -7.20081 -9716 4 44.1618 10.7755 28.2587 -0.00111917 -13.6507 16.636 -9717 6 9.15295 24.5944 6.37753 4.35763 15.0755 22.3214 -9718 4 8.87327 24.2546 5.53613 0.42871 5.14079 -20.2862 -9719 4 9.64462 25.4438 6.24707 -3.48643 -17.4971 -5.55606 -9720 6 52.5676 27.2719 21.6547 -2.39965 -30.061 -11.5856 -9721 4 52.5233 26.307 21.7841 0.332471 11.3908 13.792 -9722 4 52.7558 27.2791 20.7178 5.02488 16.4903 -8.77251 -9723 6 7.3066 16.9604 33.5537 -1.04195 2.49046 -7.43677 -9724 4 7.33543 17.7138 32.943 1.81348 -0.803559 0.920864 -9725 4 6.38938 16.6816 33.595 -7.62852 -0.129201 -7.36731 -9726 6 43.922 25.2186 7.97522 -0.776236 -10.551 19.3716 -9727 4 43.2647 24.8119 8.58447 10.2741 2.86697 -16.6436 -9728 4 43.4353 25.9147 7.53069 -5.46224 6.25576 -5.43654 -9729 6 2.0869 27.1165 13.6049 -6.62274 17.6596 -9.16822 -9730 4 2.19606 26.2295 13.9488 0.235583 -10.4047 3.43352 -9731 4 2.56841 27.1544 12.7597 2.10867 -4.70259 8.20201 -9732 6 37.3318 18.2771 2.1863 -11.4974 3.81579 3.71073 -9733 4 37.5653 17.6745 1.47223 -1.7687 -9.97531 1.83125 -9734 4 36.746 18.9091 1.7765 -5.93566 5.03593 -3.95155 -9735 6 24.9999 10.057 0.434977 -12.0635 -2.74649 0.799886 -9736 4 24.3308 10.4048 41.7106 3.78591 -9.33137 12.164 -9737 4 24.5954 9.37599 1.02184 5.69483 17.6459 -16.041 -ITEM: TIMESTEP -10 -ITEM: NUMBER OF ATOMS -9737 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 5.4990000000000002e+01 -0.0000000000000000e+00 4.1909999999999997e+01 -0.0000000000000000e+00 4.1909999999999997e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 9.97007 5.59928 0.0158605 6.82717 25.1566 0.173859 -2 2 9.62356 5.56404 40.5109 2.42388 15.8202 -17.9785 -3 2 8.17494 6.05177 40.4142 55.7411 37.9916 -4.02595 -4 3 7.24177 5.30408 40.552 -31.6102 -16.3698 1.50252 -5 4 9.18703 5.26911 0.576869 6.09491 -0.0281501 2.37507 -6 4 10.258 6.55078 0.333037 -13.6694 -25.1619 -9.93433 -7 4 10.7495 5.00053 0.227298 4.73684 -5.2578 1.97242 -8 4 10.3453 6.24708 39.9044 -16.4644 -11.4072 20.4818 -9 2 9.76873 4.13927 39.9675 -11.4588 -40.6165 34.779 -10 2 9.50273 3.78744 38.4932 15.666 28.6261 8.68394 -11 5 10.1133 2.12508 38.0108 0.295651 13.5297 3.11239 -12 2 9.21855 1.10832 39.2168 14.7368 7.58368 -1.20954 -13 4 9.08721 3.4839 40.6484 10.5431 15.7462 -21.5186 -14 4 10.7894 3.80905 40.2705 3.27862 -1.66199 -9.78219 -15 4 9.96352 4.6291 37.9056 6.4614 -19.967 -0.497951 -16 4 8.45197 3.92389 38.2658 -20.9649 -8.28542 -1.62155 -17 4 9.45855 1.42591 40.2577 0.123087 -4.74543 -3.47868 -18 4 9.48787 0.0601841 39.0477 5.23249 -11.9374 1.58081 -19 4 8.1518 1.18086 39.043 -21.148 5.31153 -2.14239 -20 1 8.09229 7.41048 40.3029 -14.2332 10.7223 -5.89196 -21 2 6.79937 8.10304 40.1889 5.24089 -19.8495 27.4218 -22 2 6.18195 7.49232 38.9365 0.114954 6.75236 -38.7125 -23 3 6.7427 7.67352 37.8124 -12.8129 -5.94191 21.2876 -24 4 8.91546 8.03754 40.1502 -4.33809 -15.705 2.93584 -25 4 6.18636 7.83053 41.1247 8.71228 4.86543 -21.2479 -26 2 7.05427 9.64124 40.1755 -39.1485 4.05492 14.7867 -27 2 5.78354 10.5475 40.1236 1.30256 17.7056 10.1762 -28 2 4.88546 10.5193 38.8862 -3.79578 -25.0164 33.8013 -29 3 5.09523 11.2746 37.9701 4.75276 20.2207 -26.2166 -30 1 3.8145 9.69296 38.9578 -10.6259 3.8922 -22.0733 -31 4 7.59986 9.93872 39.279 22.1314 0.316188 -7.87442 -32 4 7.59095 9.90263 41.1476 2.09094 2.02455 -19.3111 -33 4 6.10317 11.6308 40.2015 3.5236 -15.0099 -9.27626 -34 4 5.16114 10.4864 41.0336 -3.30627 -13.4665 3.57605 -35 4 3.54863 9.07856 39.7488 8.69916 3.95403 -0.745788 -36 4 3.18874 9.68238 38.1158 12.5738 1.24403 17.0425 -37 1 5.02604 6.79083 39.0278 7.4524 -0.797845 -45.9123 -38 2 4.17847 6.29332 37.9221 -3.7942 -15.2224 -3.95324 -39 2 2.69747 6.67222 38.2029 32.4064 16.6491 21.8024 -40 3 2.47317 7.27763 39.2627 -13.9875 -5.03172 -5.20453 -41 4 4.49693 6.75941 39.8611 -16.5463 3.77927 46.4214 -42 4 4.45927 6.7815 36.9606 1.68834 7.22657 1.16434 -43 2 4.32357 4.73766 37.6872 -14.444 16.6417 -7.09057 -44 2 3.62009 3.87951 38.7772 14.6644 -34.8859 1.43809 -45 2 5.79989 4.34797 37.5209 14.6689 -37.6664 -23.8861 -46 2 3.73665 2.34984 38.4383 -15.0607 27.3941 -9.62179 -47 4 3.8042 4.58537 36.6865 5.44811 -8.07725 9.84866 -48 4 2.54132 4.09064 38.8487 -7.82462 7.38089 1.0406 -49 4 4.05844 4.00808 39.8052 -1.99007 7.91776 -7.51683 -50 4 6.34139 4.39198 38.494 2.7915 9.59572 -3.8015 -51 4 6.26587 4.94741 36.6895 -0.816692 -0.0793993 15.4171 -52 4 5.96503 3.2496 37.1567 -11.5696 29.092 9.48874 -53 4 3.39623 2.18998 37.357 4.41378 -5.40883 18.8177 -54 4 3.12239 1.76276 39.1489 -5.35757 -4.6989 -2.16583 -55 4 4.76682 2.00075 38.5743 10.6291 -5.64517 -2.52342 -56 1 1.71265 6.3536 37.3575 -33.5913 -12.5481 -9.77554 -57 2 0.284755 6.62158 37.6816 12.6554 33.7668 -4.20076 -58 2 54.3822 5.43344 37.3699 -27.7691 3.87457 8.29319 -59 3 54.7838 4.49252 36.6867 3.01204 -3.04336 -3.37779 -60 4 1.82497 5.72672 36.5372 4.10411 3.68048 5.38879 -61 4 0.194803 6.88576 38.7694 2.48378 -12.979 2.09758 -62 2 54.7189 7.90551 36.9466 -7.72609 -12.13 5.61678 -63 2 0.656639 9.069 36.6919 -2.01357 8.03554 13.9604 -64 2 1.52683 9.2194 35.5966 7.55435 5.75852 -14.6577 -65 2 0.515029 10.1503 37.577 28.0972 23.5099 -14.6501 -66 2 2.25128 10.4257 35.3726 -4.96866 -39.5758 -10.6477 -67 2 1.27413 11.3326 37.3973 2.53894 16.486 1.64204 -68 2 2.1477 11.4375 36.2812 10.2448 65.1187 39.3263 -69 4 53.8018 8.25583 37.5371 13.1335 -2.90056 -11.9634 -70 4 54.3208 7.62968 35.9579 -2.73912 -6.0948 -8.85904 -71 4 1.62786 8.40831 34.848 -1.08621 1.70246 3.68663 -72 4 54.8519 10.113 38.4282 -15.3846 -1.92761 17.9785 -73 4 2.932 10.5406 34.5118 -0.192368 -3.19302 0.526177 -74 4 1.1987 12.2443 38.1226 0.692592 -32.2473 -20.0357 -75 4 2.79857 12.4271 36.2097 -23.9561 -41.0367 -3.09354 -76 1 53.0712 5.5328 37.7893 -5.57771 32.7805 23.2413 -77 2 51.973 4.62909 37.5111 5.69369 -27.8287 -42.174 -78 2 50.7933 5.44178 36.9635 6.83138 2.9595 14.8019 -79 3 50.2601 6.28483 37.7029 -2.00888 -3.43203 -15.9694 -80 4 52.7232 6.34215 38.4237 19.8206 -30.3225 -23.0649 -81 4 52.294 3.8899 36.6472 -5.7065 17.91 27.0613 -82 2 51.558 3.79481 38.7755 -4.51595 7.33433 1.21121 -83 2 50.3828 2.83682 38.5018 -9.13901 -44.4412 -29.5986 -84 2 52.8166 3.00155 39.2294 -15.7012 -7.04664 11.9409 -85 4 51.1774 4.47766 39.5861 12.1653 -0.853429 -2.8896 -86 4 50.5215 2.15128 37.5875 8.57056 17.9281 16.1392 -87 4 49.4053 3.30815 38.2892 0.50336 12.9055 3.57196 -88 4 50.1645 2.10956 39.3273 7.20165 10.7054 2.61524 -89 4 53.3305 3.56036 40.0335 2.85201 1.25263 3.90533 -90 4 53.556 2.88446 38.4204 4.77396 -6.45058 -3.13498 -91 4 52.5519 1.98529 39.6413 5.25091 8.27159 -2.68354 -92 1 50.4114 5.20625 35.6841 -20.1476 8.87025 -3.50293 -93 2 49.1688 5.73971 35.0966 -28.9774 8.99335 -1.66554 -94 2 48.0726 4.67952 35.3573 13.5632 -27.7837 -20.7653 -95 3 48.2724 3.51151 34.9309 -12.9152 20.0019 12.3092 -96 4 50.758 4.377 35.1895 1.67728 -2.63512 -1.50997 -97 4 48.8371 6.69602 35.5973 10.748 -7.18216 5.66994 -98 2 49.2038 6.04752 33.5367 10.0422 21.5226 29.5984 -99 2 47.9776 6.84135 32.9981 5.60977 17.6728 -19.5296 -100 2 48.06 7.31101 31.4919 41.3779 8.51018 8.58065 -101 2 48.2223 6.22581 30.3803 10.2277 10.7815 -8.37061 -102 1 48.1882 6.76889 29.0124 -44.0668 -20.3552 -6.98541 -103 4 49.2392 5.11894 32.9842 10.5057 -23.1259 -12.3022 -104 4 50.1653 6.62923 33.3927 -11.345 -5.02104 -10.4632 -105 4 47.825 7.77207 33.6051 2.48464 -5.23088 2.05035 -106 4 47.0343 6.2773 33.0942 -1.95432 -7.79908 6.21428 -107 4 48.9189 8.07819 31.4105 -13.7973 -19.6161 -0.159439 -108 4 47.1832 7.92091 31.2683 -17.7289 5.61577 -2.96622 -109 4 47.3306 5.536 30.4593 16.0468 -5.76301 1.4082 -110 4 49.2642 5.74618 30.4425 -24.8663 -4.45667 9.08666 -111 4 48.9827 7.28362 28.7526 29.3958 17.558 -6.10605 -112 4 47.3901 7.43056 28.8463 17.4375 -26.0151 1.0329 -113 4 48.1308 5.99149 28.2967 -4.23626 26.2635 18.8845 -114 1 46.923 5.03715 35.9679 -17.5656 23.7329 15.0201 -115 2 45.6707 4.26397 36.0383 7.41887 0.1342 36.2715 -116 2 44.9083 4.3955 34.7419 -9.99807 18.7078 -56.0122 -117 3 45.3082 5.1515 33.8118 -11.5681 -21.3087 27.1246 -118 4 46.8218 5.98238 36.4144 8.23522 -16.4135 -11.8728 -119 4 45.8989 3.17264 36.1884 2.80321 2.94058 -5.13324 -120 2 44.7401 4.70263 37.2808 -1.60464 -36.3649 -20.2774 -121 3 44.4616 6.07663 37.208 27.8602 32.4116 16.0792 -122 2 45.244 4.25605 38.6868 21.6281 49.2853 -20.5016 -123 4 43.7497 4.17807 37.1099 13.0537 7.54308 5.65065 -124 4 45.2592 6.57873 37.5303 -28.9412 -17.1189 -11.5145 -125 4 45.9129 5.11546 39.1089 -19.7485 -23.953 -1.10378 -126 4 45.8752 3.36487 38.6536 3.71139 -12.8851 -1.61893 -127 4 44.3595 4.03827 39.3021 -3.33201 1.23649 16.0156 -128 1 43.7613 3.66416 34.5997 13.2589 -16.0433 44.4251 -129 2 42.7828 3.62815 33.5465 18.9204 -1.21878 -42.6601 -130 2 41.7763 4.78741 33.7016 8.26701 -3.22526 52.4496 -131 3 41.2647 5.35582 32.7525 -2.05798 3.57411 -28.7638 -132 4 43.4932 3.04471 35.4154 4.99312 14.665 -20.8764 -133 4 43.36 3.79542 32.5266 -17.2288 -0.741434 30.8189 -134 2 42.0901 2.2209 33.4572 -3.06831 -30.079 -8.91003 -135 2 42.9343 0.899345 33.7586 6.86735 -2.69949 -8.81151 -136 2 42.2038 41.463 33.3849 1.50493 16.9918 14.9247 -137 2 44.2499 0.864187 32.9361 47.2855 12.5868 41.6398 -138 4 41.5678 2.05281 32.481 6.79941 12.0418 -2.16148 -139 4 41.2531 2.16469 34.1657 -6.29243 10.0771 8.19014 -140 4 43.198 0.869694 34.8519 -1.4112 0.953999 -4.44245 -141 4 42.8702 40.5903 33.6002 -4.10478 0.398246 -9.68788 -142 4 41.7896 41.4589 32.3582 7.27854 -3.68783 -7.38435 -143 4 41.3262 41.3063 34.0224 -6.75638 1.39507 6.42691 -144 4 44.0947 0.829251 31.8728 -5.75954 4.64229 -28.5029 -145 4 44.9396 41.8855 33.1737 -20.9549 12.1515 -1.19165 -146 4 44.9309 1.76601 33.2059 -22.5069 -20.3291 -10.4095 -147 1 41.5145 5.2236 34.9901 10.2672 4.08625 -51.0356 -148 2 40.6676 6.35891 35.268 -24.1778 -10.7223 -7.79527 -149 2 41.3691 7.72376 35.0974 2.95483 13.7574 -3.11119 -150 3 40.6975 8.75349 34.8431 -2.15612 -12.5202 3.44484 -151 4 41.8176 4.64617 35.7553 2.04542 -7.36824 24.1106 -152 4 39.8621 6.3427 34.4551 10.5786 9.41727 7.44594 -153 2 39.8405 6.1283 36.5756 19.8539 -2.67173 26.8296 -154 3 40.7601 5.89106 37.6735 -0.128972 20.3018 -14.678 -155 2 38.9248 4.89402 36.5497 -24.3083 -6.19306 -11.8519 -156 4 39.228 7.01129 36.8511 -0.372961 8.24506 -6.20484 -157 4 41.1549 6.75425 37.8536 -4.13097 -9.7211 -3.01543 -158 4 38.1722 4.94482 35.71 1.05658 9.14576 13.4136 -159 4 38.3953 4.71355 37.5213 -1.28546 9.2328 -6.30902 -160 4 39.3771 3.92967 36.3433 23.1336 -11.0543 -1.24287 -161 1 42.7302 7.8059 35.1562 3.49276 1.34371 4.78693 -162 2 43.5269 8.99303 34.9539 -8.19772 -21.7996 13.9087 -163 2 44.4646 9.39471 36.0778 41.0762 49.5413 -62.5687 -164 3 45.3993 10.2183 35.7654 -29.643 -36.0587 21.7786 -165 4 43.357 7.05719 35.4614 -7.13629 -15.5308 5.06399 -166 4 44.0803 8.92821 34.0189 14.2015 -9.60403 -10.8131 -167 4 42.9032 9.83742 34.7399 -16.6431 23.0824 1.78637 -168 1 44.28 8.95267 37.3076 -5.41717 -6.01048 56.4016 -169 2 45.1954 9.30059 38.3934 14.0544 9.09198 9.45122 -170 2 46.5736 8.71838 38.034 -4.40481 25.0392 4.24124 -171 3 46.7239 7.52665 37.7592 -2.06685 -10.8071 -7.31186 -172 4 43.4369 8.46722 37.66 -0.808029 1.80219 -13.797 -173 4 45.2932 10.4319 38.4595 -5.35026 -12.3633 -15.6489 -174 2 44.7775 8.83735 39.8303 19.1756 -23.9015 -7.23155 -175 2 45.4882 9.63492 40.9425 5.24315 -15.5914 27.8506 -176 2 45.0424 11.1143 41.0465 6.36216 -11.291 -10.339 -177 2 45.9827 11.9035 0.041605 38.3537 -2.96327 34.4916 -178 1 45.5586 13.2421 0.396463 -0.785075 15.3756 28.9492 -179 4 44.9912 7.72238 39.9953 -4.79728 17.8629 -7.78445 -180 4 43.7049 8.96345 39.9422 -22.2512 0.44531 4.07292 -181 4 46.5908 9.56019 40.8161 0.364544 3.82252 -6.52459 -182 4 45.3434 9.10335 0.0599805 -5.24686 13.9981 -23.7842 -183 4 44.0132 11.1324 41.4274 -10.2695 3.39123 6.70816 -184 4 44.9981 11.6023 40.04 1.8072 0.416607 6.15726 -185 4 47.0442 11.9436 41.5493 -17.6115 6.73335 -5.13538 -186 4 46.1824 11.4052 1.05233 -16.0491 -0.928483 -18.7699 -187 4 45.666 13.9003 41.5429 -6.15709 2.25656 -0.794581 -188 4 46.187 13.6261 1.17403 -31.6799 -14.737 -27.4943 -189 4 44.5482 13.2658 0.707841 33.0262 6.71149 -7.77427 -190 1 47.5786 9.61919 37.9975 -0.262725 18.6124 2.96873 -191 2 48.9681 9.33197 37.6414 -20.2336 1.72319 -17.1083 -192 2 49.7588 9.70622 38.88 39.5209 -76.7499 14.8721 -193 3 49.6145 10.763 39.4317 -9.44289 38.5374 13.5639 -194 4 47.4009 10.6083 38.3248 7.77058 -18.5649 -8.96176 -195 4 49.0172 8.23798 37.4216 9.46753 0.884559 0.506936 -196 2 49.3323 10.1282 36.3163 3.6714 0.82331 31.2642 -197 3 48.3563 9.85046 35.3281 -8.1318 -4.77519 -4.71381 -198 2 50.6865 9.72677 35.695 -19.0046 0.743943 -11.7808 -199 4 49.2557 11.2077 36.6021 8.67648 2.0602 -8.11811 -200 4 47.5419 10.2678 35.5977 -2.15846 0.170791 -0.678761 -201 4 50.8563 10.2671 34.7416 2.67544 8.24981 1.47477 -202 4 50.7066 8.66813 35.3754 2.1247 -7.47433 7.78713 -203 4 51.5309 9.954 36.3541 9.43429 -0.352141 7.40173 -204 1 50.5004 8.65755 39.48 -48.513 49.986 -45.0014 -205 2 51.0618 8.74392 40.7907 20.8089 -26.4742 28.5407 -206 2 52.5708 8.35776 40.7906 -32.7343 -31.0986 -30.3541 -207 3 52.9098 7.36002 40.1044 19.6712 31.5314 12.7437 -208 4 50.5882 7.8265 38.898 12.8881 -18.9119 10.2231 -209 4 50.9863 9.78895 41.141 -1.46865 8.60563 4.12328 -210 2 50.3037 7.79505 41.8358 -16.725 28.936 13.8764 -211 2 50.252 6.27959 41.4904 27.2589 15.6434 -4.64867 -212 2 48.8609 8.35011 0.225019 8.85004 14.588 -17.6069 -213 2 49.3953 5.42325 0.497373 -18.8945 7.05888 30.2377 -214 4 50.814 7.95159 0.918621 8.35305 -8.94958 -7.30269 -215 4 51.3186 5.93048 41.4774 -6.84536 -5.23847 5.64953 -216 4 49.9408 6.1608 40.4387 -8.33431 -3.05112 -5.55566 -217 4 48.166 7.96072 41.344 -1.46 7.63128 5.53427 -218 4 48.8165 9.51657 0.246026 0.467008 -30.2893 -0.065267 -219 4 48.5175 7.97406 1.21641 -4.07563 3.27994 -1.48455 -220 4 48.2983 5.58085 0.347667 5.50609 -0.627552 -5.84055 -221 4 49.5344 5.58322 1.60624 7.63779 5.91871 -13.4594 -222 4 49.5909 4.36583 0.361303 3.03099 -20.7712 -9.01704 -223 1 53.3669 9.15083 41.5136 39.5682 14.7354 5.79836 -224 2 54.8443 9.26777 41.6313 -32.7918 27.0996 3.53674 -225 2 0.372396 8.2907 0.722751 15.0567 -33.4937 20.6099 -226 3 54.8856 8.2259 1.87915 11.4238 -3.26125 -20.3466 -227 4 52.9167 9.73978 0.288924 -10.841 14.2188 11.5997 -228 4 0.25416 9.07559 40.636 9.98484 -5.7038 -17.1316 -229 2 0.351513 10.7152 0.19938 0.985642 14.1538 -10.6635 -230 3 54.4575 11.7797 41.7528 -11.3464 -18.6066 -9.73211 -231 2 1.66903 11.1049 41.4122 7.34382 -22.4378 -10.8926 -232 4 0.4803 10.8256 1.29559 2.15483 -15.9854 6.57991 -233 4 54.1789 12.1729 0.660397 -4.76608 7.18995 2.46446 -234 4 2.02372 12.0909 41.706 2.9877 17.6459 6.95349 -235 4 1.57896 11.139 40.2943 0.339955 -2.68366 6.65003 -236 4 2.50746 10.4017 41.6821 -7.50419 3.69742 -2.77337 -237 1 1.45709 7.55056 0.343709 0.783377 10.0466 -6.42735 -238 2 2.26763 6.65075 1.15078 -32.6055 -6.94536 -7.22798 -239 2 3.71498 6.9634 0.985171 49.9575 39.4499 -62.468 -240 3 4.16139 7.41516 41.7733 -24.7374 -20.1855 46.264 -241 4 1.86812 7.64334 41.3079 -3.10568 2.79536 2.39364 -242 4 2.02547 6.77359 2.21072 -7.15361 5.99983 10.1715 -243 2 1.97017 5.19949 0.677115 9.24237 23.8034 -8.70369 -244 2 0.525 4.76245 0.942436 -1.25511 -23.3688 27.6866 -245 2 0.292475 3.39123 0.300736 12.896 -21.1671 11.4366 -246 2 0.300138 4.59931 2.47443 -32.0383 1.7301 9.08136 -247 4 2.70003 4.54767 1.15632 6.2908 -16.3803 10.1517 -248 4 2.22696 5.13751 41.5068 -3.29253 -1.30987 -4.15087 -249 4 54.7656 5.47042 0.590489 -8.39992 14.3218 -15.0438 -250 4 54.2418 3.05018 0.328915 -13.2626 1.11831 3.00682 -251 4 0.884488 2.58096 0.823664 -4.50955 14.351 -5.98985 -252 4 0.593908 3.34298 41.1636 3.48003 3.40906 -16.1017 -253 4 0.952355 3.83641 2.92287 8.67303 -5.41594 2.10418 -254 4 54.195 4.2418 2.71744 29.7111 15.4634 -7.25797 -255 4 0.523461 5.5584 3.03176 -8.55492 -11.4476 -4.98522 -256 1 4.54724 6.69628 2.0028 -11.6083 -5.66543 -5.23244 -257 2 5.9708 6.78048 2.07185 29.6953 24.7002 11.5216 -258 2 6.62679 5.47067 2.57826 -56.9161 -25.5018 -48.7527 -259 3 7.55514 5.44421 3.3345 43.3901 -4.04961 27.9945 -260 4 4.11753 6.29088 2.82459 -1.31884 -6.15538 19.0144 -261 4 6.38329 6.99012 1.0501 -1.44469 -12.2628 1.79191 -262 2 6.4556 7.99651 2.97484 -29.1307 10.2847 -18.0571 -263 2 6.5028 9.34873 2.22705 -18.2939 24.7932 5.04877 -264 2 6.67525 10.5485 3.20576 -19.6949 -28.8822 -17.9407 -265 3 7.83409 10.9407 3.49149 14.4815 4.00472 5.8048 -266 3 5.6204 11.0576 3.67938 3.00737 1.04452 3.25275 -267 4 7.46376 7.72864 3.29072 15.5933 3.84479 14.8832 -268 4 5.82416 8.22265 3.87848 3.62309 -20.6245 -0.107855 -269 4 5.50278 9.55154 1.65377 27.7023 -9.35583 7.15892 -270 4 7.36204 9.37759 1.52673 -1.86837 -2.39822 -10.1271 -271 1 6.01547 4.32119 2.13096 24.825 18.8056 21.8908 -272 2 6.40109 2.94617 2.38906 -11.7575 -20.1643 -12.9237 -273 2 7.81521 2.61654 1.77783 -56.2322 2.45294 33.4207 -274 3 8.31478 3.35811 0.966233 17.239 19.087 -22.9985 -275 4 5.23593 4.40493 1.50032 -13.4301 6.78787 -12.4159 -276 4 6.42741 2.74871 3.48587 6.57798 6.02642 3.28221 -277 2 5.2086 2.00284 1.82478 32.9723 -19.5112 -16.552 -278 2 3.90497 2.10853 2.63909 4.11684 35.775 58.6384 -279 2 4.90372 2.28313 0.318971 -25.0993 -16.9694 6.10511 -280 4 5.56913 0.900136 1.85726 -4.66192 22.2662 6.6067 -281 4 4.03562 1.77943 3.74204 2.08752 -4.13501 -29.3045 -282 4 3.08076 1.58512 2.20328 -21.6762 -25.4002 -11.7361 -283 4 3.47043 3.14079 2.79739 15.5883 -5.24062 -11.8252 -284 4 4.40039 3.24668 0.146776 -5.79992 5.24774 -1.28692 -285 4 4.20501 1.47402 41.8336 8.41255 14.6516 3.66501 -286 4 5.77159 2.28177 41.569 16.6343 -1.64949 -4.80555 -287 1 8.4358 1.54559 2.27475 36.6082 -11.5601 -11.8896 -288 2 9.77403 1.09441 1.8307 -27.8835 12.6882 -14.7267 -289 2 9.60932 41.7912 0.904414 -8.95822 -4.80133 -2.77359 -290 3 8.60977 41.0717 1.04857 16.9017 -0.350054 -8.54673 -291 4 7.96937 0.851078 2.83344 -16.1443 -13.3321 15.6909 -292 4 10.1447 1.96102 1.23179 21.7718 -7.90657 2.9301 -293 2 10.6071 0.627222 3.03652 -0.441548 -3.06629 28.3632 -294 2 11.1182 1.69736 4.03374 -39.6019 -9.33118 23.345 -295 2 12.4276 2.26482 3.60541 40.3504 -3.80329 2.03759 -296 3 13.4833 1.65854 4.00477 -10.9735 16.3163 -6.96273 -297 3 12.4619 3.21875 2.76405 -4.75337 -1.04793 7.93588 -298 4 11.5429 0.117807 2.72279 -4.90068 -9.43781 -6.0473 -299 4 9.98495 41.7532 3.61242 16.0495 13.2539 -10.4034 -300 4 11.2741 1.17979 5.05068 -3.18835 9.28581 -16.8758 -301 4 10.3234 2.48031 4.23808 10.2695 -6.11036 -3.24845 -302 1 10.6563 41.4604 0.0588169 -6.20046 -15.666 -8.24155 -303 2 10.7096 40.1842 41.1911 4.64874 21.5238 9.65168 -304 2 10.6577 38.9638 0.161439 -6.67174 -46.3648 23.9629 -305 3 10.1435 37.8848 41.6696 11.1653 29.5239 15.2576 -306 4 9.85832 40.1011 40.5066 -14.3391 4.69386 -5.52668 -307 2 12.0141 40.2124 40.3653 4.26726 1.71904 -5.44169 -308 2 12.4668 41.6661 40.4777 -1.00635 15.6111 -33.0282 -309 2 11.8673 0.323303 41.767 -12.6506 -21.5702 -15.1443 -310 4 11.8545 39.873 39.2959 0.539662 6.91875 10.5587 -311 4 12.8304 39.5641 40.7546 -3.32338 -3.68521 7.20301 -312 4 12.0951 0.327352 39.5607 -0.26902 -6.73625 15.8499 -313 4 13.5766 41.7696 40.398 -3.05617 -0.547794 6.53436 -314 4 11.6542 1.3898 41.6565 2.06281 16.0871 1.21765 -315 4 12.5433 0.162045 0.691867 15.5992 2.8717 16.0141 -316 1 11.2193 39.0766 1.4086 -4.36655 24.7542 -22.059 -317 2 11.4309 38.0888 2.42328 2.01986 -2.25877 10.0578 -318 2 10.2357 37.7662 3.3374 -3.13249 5.62439 -12.9442 -319 3 10.4243 36.9709 4.25096 -6.41092 -9.96708 1.94465 -320 4 11.5904 40.0068 1.66465 -1.36758 -8.10945 4.45955 -321 4 11.6246 37.1209 1.91909 1.66244 -5.96089 -4.69733 -322 2 12.7089 38.4628 3.26447 -19.7243 1.96837 18.865 -323 3 12.593 39.7548 3.85012 -16.3579 -13.4437 -0.292868 -324 4 13.6002 38.4999 2.63657 13.9756 -7.10852 -11.694 -325 4 12.8962 37.7302 4.10036 -1.36843 4.44789 -10.4248 -326 4 11.9859 39.6657 4.60642 10.4094 13.6351 -5.41979 -327 1 9.02275 38.3618 3.12708 -24.8633 34.0603 -47.8229 -328 2 7.7797 38.1104 3.9237 -5.5143 -4.40103 -12.4219 -329 2 6.80948 37.1627 3.16843 27.134 16.5749 8.61656 -330 3 6.86683 37.0056 1.95165 6.52379 13.0808 -10.3152 -331 4 8.81363 38.9852 2.21874 13.7891 -35.0234 50.9651 -332 4 8.06628 37.5753 4.84119 7.22917 -10.5654 7.4735 -333 2 7.01568 39.4093 4.3407 2.69101 -11.9593 -14.7657 -334 2 7.81876 40.1019 5.42325 -6.79454 3.60365 -28.1432 -335 3 8.28496 41.241 5.20721 -2.75331 10.4655 -0.123769 -336 3 8.08719 39.4782 6.47272 0.652509 -5.2024 22.4807 -337 4 5.97814 39.1687 4.67547 5.82193 1.31451 7.85599 -338 4 6.83632 40.0167 3.42407 6.48365 7.00102 3.75656 -339 1 5.92582 36.4787 3.90047 -14.2639 -13.8348 21.4567 -340 2 4.95916 35.6178 3.24268 -4.4575 6.83929 8.3992 -341 2 3.83929 36.4769 2.71202 -44.4588 -49.3176 -48.5312 -342 3 3.60925 37.6169 3.05258 2.07424 26.7384 14.4764 -343 4 5.8145 36.534 4.942 7.63157 5.21975 -16.3776 -344 4 5.40617 35.1414 2.34351 4.65472 -4.22423 0.555341 -345 2 4.39718 34.509 4.16235 13.2774 -34.7614 9.16528 -346 3 3.98438 35.0519 5.39575 -10.4467 6.31908 32.28 -347 2 5.50619 33.4543 4.48033 -18.4692 -3.54598 29.0115 -348 4 3.53919 33.9402 3.74776 -4.47694 5.79242 -10.2957 -349 4 3.62452 34.3759 6.00064 11.5458 5.5573 -22.0279 -350 4 5.86065 32.9579 3.58801 8.19644 -6.15464 -22.9143 -351 4 5.08151 32.5761 5.12909 16.3877 29.7333 -11.6263 -352 4 6.39565 33.9521 4.95041 -3.85278 -8.84208 3.35803 -353 1 2.97294 35.7888 1.83357 24.6732 25.9217 25.2152 -354 2 1.71267 36.3687 1.37347 -5.03432 -5.896 10.5631 -355 2 0.744229 36.5497 2.58991 -5.24139 24.3125 -23.8477 -356 3 54.9871 37.5497 2.63122 18.6385 -17.0409 3.73872 -357 4 3.28773 34.8825 1.44268 -6.98273 2.93822 -0.272558 -358 4 1.87243 37.434 1.07109 4.86902 -3.5162 -5.74397 -359 2 1.111 35.5523 0.154125 -16.9781 -2.34719 28.1775 -360 2 1.71191 35.9998 40.7076 5.75717 0.931703 -28.4951 -361 2 54.5365 35.7134 0.116808 -8.16561 0.919103 1.38616 -362 2 3.27145 35.9095 40.6267 -43.0781 7.09941 -3.6072 -363 4 1.31237 34.4411 0.36052 2.96229 18.9121 -10.1464 -364 4 1.38444 37.0145 40.3207 4.07875 -5.77915 19.4423 -365 4 1.27316 35.3433 39.9124 8.37762 -5.40948 6.65521 -366 4 54.0772 35.0942 41.2103 3.74338 3.48587 4.89864 -367 4 54.2123 36.7722 41.8688 5.5832 -2.69651 -3.34762 -368 4 54.0157 35.4055 1.08169 10.5414 -0.491815 -14.4897 -369 4 3.61367 34.902 40.8802 7.83264 -12.2373 1.45006 -370 4 3.69229 36.6315 41.3343 12.2091 5.94613 6.19684 -371 4 3.59275 36.1798 39.604 6.95495 -3.49191 -4.00644 -372 1 0.74604 35.6172 3.54454 -3.3388 -35.9018 49.598 -373 2 0.0112331 35.6552 4.85892 21.257 7.22823 -39.6883 -374 2 0.198256 37.0471 5.48367 -2.86302 -31.8341 -17.2866 -375 3 54.1912 37.6952 5.75353 -1.48181 26.0574 3.92406 -376 4 1.16676 34.6739 3.4098 -0.571923 12.3969 -9.16993 -377 4 53.9399 35.5324 4.59955 -13.6683 1.62606 4.36563 -378 2 0.479844 34.4894 5.77304 -8.63544 -0.437888 22.4632 -379 2 54.7769 34.3327 7.14546 -8.87326 -9.27459 2.92058 -380 2 0.0146857 35.4787 8.12524 6.60033 -5.57439 2.5368 -381 3 54.0952 36.3427 8.3329 8.35004 -1.43527 5.86114 -382 3 1.11008 35.478 8.75909 4.47833 6.11486 1.03148 -383 4 1.57132 34.5563 5.98457 -0.698959 1.91632 -4.64924 -384 4 0.309529 33.5134 5.28188 2.4365 -3.54209 -11.468 -385 4 0.179249 33.4003 7.64738 0.479338 5.67065 -5.66203 -386 4 53.6776 34.105 7.04833 9.83525 6.91672 -4.06122 -387 1 1.48459 37.3964 5.63734 26.9411 18.0032 -4.38534 -388 2 2.00708 38.6625 6.18614 -17.3218 -26.0277 -29.9987 -389 2 1.56827 39.8885 5.33406 1.07082 -15.6319 68.2882 -390 3 1.08143 40.8395 5.94485 1.04665 3.34176 -10.6171 -391 4 2.21263 36.6994 5.39095 -3.57075 5.04293 0.958686 -392 4 1.48422 38.7142 7.17744 15.2971 12.5748 0.959573 -393 2 3.55969 38.5843 6.25222 7.32448 -15.8569 15.0135 -394 2 4.09689 39.7132 7.09894 -5.63198 1.92213 9.01267 -395 3 4.56636 40.7179 6.56654 0.030916 3.04529 -1.1693 -396 1 3.96361 39.556 8.43894 1.042 12.9555 16.4237 -397 4 4.05831 38.7157 5.24953 -10.2579 -5.90723 4.64011 -398 4 3.91694 37.5778 6.70114 -5.07122 23.1073 -10.2752 -399 4 3.40266 38.7698 8.86734 10.6722 14.2638 -7.23316 -400 4 4.31989 40.3411 9.06061 -10.7144 -22.9188 -14.0526 -401 1 1.60475 39.819 4.02334 -43.55 39.5967 -43.6917 -402 2 0.959151 40.8062 3.12947 9.93922 10.0651 20.657 -403 2 54.4776 41.0208 3.48285 -52.4492 -13.4217 15.5726 -404 3 53.9715 0.237442 3.65017 19.1527 -10.2385 2.60078 -405 4 2.04263 39.1125 3.49268 25.4866 -43.7222 -11.6271 -406 4 1.43469 41.7946 3.36052 -1.16639 -0.650149 -3.04645 -407 2 1.13376 40.5205 1.61049 -4.45578 -2.70165 -27.9407 -408 2 0.490261 41.6149 0.695896 4.53105 0.20202 29.6943 -409 2 2.64975 40.4484 1.23692 -3.92583 -1.39436 -18.6979 -410 4 0.60342 39.5705 1.32385 8.41785 -1.89228 7.96418 -411 4 54.3692 41.6195 0.82936 4.25856 9.6792 3.81375 -412 4 0.622371 41.4492 41.5424 7.52435 -6.48816 -19.7965 -413 4 0.973053 0.688907 0.936332 -12.1275 -4.49455 -2.44597 -414 4 2.86969 40.4983 0.122209 -12.9804 -12.5133 18.6513 -415 4 3.14027 39.5547 1.69882 2.20392 3.04031 -6.93039 -416 4 3.17994 41.3387 1.56797 8.55742 10.8937 16.8775 -417 1 53.6665 39.902 3.64569 3.02926 35.878 11.6697 -418 2 52.2466 39.9148 4.06102 19.2385 27.0707 -26.8098 -419 2 52.053 40.5369 5.44904 5.36155 -11.3244 -6.70427 -420 3 51.0493 41.2119 5.6977 3.00195 1.8183 -1.23959 -421 4 54.0359 38.9941 3.4462 12.1828 -26.316 -3.91411 -422 4 51.7731 40.6655 3.34079 -4.82064 -14.7659 11.8755 -423 2 51.582 38.5149 3.95778 -5.61462 -20.1546 -9.91009 -424 2 51.4355 37.9559 2.49174 21.0062 -12.2216 22.8132 -425 2 51.0144 36.4629 2.37849 -12.7289 -13.0945 -11.3158 -426 2 50.8009 35.9817 0.883468 22.3055 45.8074 13.5352 -427 1 50.1864 34.6873 0.684667 2.36531 28.1154 -10.556 -428 4 50.5344 38.5648 4.38466 13.3699 -2.49694 2.21203 -429 4 52.2198 37.7725 4.53757 -13.8611 9.51826 -2.20414 -430 4 52.4594 37.9738 2.01537 -10.7122 14.3169 -4.94324 -431 4 50.6781 38.6054 2.01085 7.27079 0.282464 -15.5314 -432 4 50.0599 36.3043 2.92579 -2.19776 -0.350037 2.41174 -433 4 51.7586 35.7685 2.83822 0.223715 4.6579 4.31096 -434 4 51.8274 35.9658 0.402852 -15.0801 -2.53131 0.358002 -435 4 50.2142 36.8299 0.38331 4.02889 -26.7998 -2.47013 -436 4 50.6312 33.9821 1.2741 -7.74727 -6.99272 -14.4028 -437 4 50.1255 34.5169 41.5875 17.6482 -15.4813 7.31014 -438 4 49.2229 34.7469 0.909632 -22.6621 -5.40937 19.0501 -439 1 53.014 40.2496 6.3528 -7.33511 22.7823 24.6419 -440 2 53.0995 40.7279 7.73814 -49.8191 -29.044 -3.24915 -441 2 53.1557 0.329785 7.7965 36.8238 12.814 -39.8954 -442 3 52.5287 0.997511 8.60414 -15.9304 4.02299 13.5617 -443 4 53.7341 39.5741 6.15629 12.7417 -17.108 -13.0125 -444 4 52.0658 40.401 8.2322 35.0205 13.5384 -7.46142 -445 2 54.2887 40.0362 8.44194 -31.1952 -6.28028 37.9979 -446 4 54.3393 40.3597 9.51814 11.9598 15.0179 -15.3163 -447 4 0.207826 40.1934 7.85611 17.4499 5.7482 6.56468 -448 4 54.1321 38.9464 8.61757 0.233079 -2.0185 -17.8759 -449 1 53.9798 0.938968 6.8679 -0.195991 -19.5991 -5.8991 -450 2 54.0539 2.3703 6.69095 -13.0728 33.3033 12.6105 -451 2 52.7411 3.03405 6.19669 -13.7918 -57.342 -43.9621 -452 3 52.3429 4.1409 6.51048 0.805927 21.8583 24.6591 -453 4 54.6966 0.402301 6.30051 -22.9471 7.504 14.9388 -454 4 54.1387 2.85352 7.70963 6.90446 -7.48262 -5.16091 -455 2 0.230181 2.82991 5.77971 -8.39605 37.5401 -18.7849 -456 2 1.62806 2.36187 6.13631 43.8101 -17.859 13.5365 -457 2 2.01439 2.63812 7.6434 4.44409 -15.8917 -34.667 -458 2 3.251 1.82053 8.03886 10.3698 -25.435 21.3536 -459 1 3.78609 2.13458 9.37971 -1.03569 -21.7613 -70.4054 -460 4 0.236987 4.00662 5.72725 -0.841737 -32.3075 1.88093 -461 4 55.0233 2.47547 4.72977 -1.92078 4.0191 4.58104 -462 4 2.43886 2.84427 5.52141 -13.7997 6.98566 -1.14785 -463 4 1.8001 1.26942 5.8525 -13.1218 12.7308 11.199 -464 4 1.17734 2.2629 8.25415 -4.76662 9.03037 15.6753 -465 4 2.26439 3.72233 7.77766 -11.2971 -1.006 3.39024 -466 4 4.0605 1.91272 7.29579 6.96563 5.43042 -1.59904 -467 4 3.03028 0.709673 8.06144 -4.99399 12.6268 -3.20223 -468 4 3.89697 1.2978 9.90866 2.2165 -13.9672 17.3419 -469 4 3.11983 2.70535 9.83652 -2.18207 25.7622 26.4666 -470 4 4.71792 2.51816 9.23842 -3.78155 13.4581 18.6473 -471 1 52.0021 2.30339 5.27929 12.8772 20.7449 44.6796 -472 2 50.6928 2.72834 4.84618 -13.8318 -0.832969 -24.58 -473 2 49.579 2.58092 5.91693 0.565718 25.7533 -2.22664 -474 3 48.7752 3.51298 6.10069 9.60089 -13.9081 0.0850852 -475 4 52.4111 1.47967 4.84803 3.54375 -13.752 -6.04623 -476 4 50.7183 3.81521 4.5849 2.62435 0.742467 8.46338 -477 2 50.3339 2.0499 3.47904 12.4361 -26.7668 8.24264 -478 2 51.3981 2.34325 2.36407 -25.9391 22.844 -14.5031 -479 2 48.9153 2.37958 2.98651 -2.89914 40.9383 9.35249 -480 2 51.1891 1.41918 1.15407 38.5806 -15.4927 -30.3188 -481 4 50.4158 0.92469 3.65006 -8.90797 13.02 4.48026 -482 4 52.4055 2.20648 2.74929 18.7984 -5.45377 5.09466 -483 4 51.3666 3.42411 2.00589 -1.76359 -13.5005 7.53435 -484 4 48.1353 2.36077 3.79579 2.75746 -16.6411 -10.078 -485 4 48.6799 1.76326 2.11438 -14.9792 -11.0957 -5.84075 -486 4 48.8325 3.45193 2.63807 7.50371 -11.7896 -0.401559 -487 4 52.1004 1.43799 0.414216 -21.3416 1.39174 26.2203 -488 4 50.3409 1.68288 0.503068 -10.2032 3.93981 2.99084 -489 4 51.0565 0.33979 1.46483 1.72575 11.8892 -3.22767 -490 1 49.5807 1.53255 6.75244 19.5889 -24.3514 7.76629 -491 2 48.7262 1.39688 7.92951 3.12598 20.2674 -1.73108 -492 2 48.8873 2.63773 8.86406 -22.8968 -16.6402 -5.42224 -493 3 47.8891 3.05472 9.45614 -0.472007 6.27789 -5.95623 -494 4 50.2352 0.731103 6.58688 -10.8709 15.7502 1.66713 -495 4 47.6402 1.39986 7.60999 11.2933 -0.131061 -1.07735 -496 2 49.0614 0.0990051 8.70607 -29.9824 -25.1823 -11.7347 -497 2 48.2869 41.7602 10.01 13.4599 -0.122667 29.7563 -498 2 46.7828 0.0292377 10.0132 -0.929007 -24.4408 -23.1824 -499 3 46.2118 0.52149 10.9702 -12.9016 15.2185 13.9881 -500 1 46.1401 41.3429 8.96595 27.5879 22.2376 34.4467 -501 4 50.107 0.108866 8.97457 27.7162 -1.73681 3.74735 -502 4 48.8999 41.0818 8.03917 5.36927 20.2302 10.0129 -503 4 48.7183 0.460982 10.852 -8.35522 8.57003 -12.646 -504 4 48.4869 40.755 10.454 -1.65554 -4.90235 -14.5783 -505 4 46.6392 40.8985 8.22302 16.4703 -11.2583 -22.7525 -506 4 45.1487 41.2958 8.97726 -40.9601 -1.33251 0.190018 -507 1 50.0995 3.17318 9.05078 3.95851 -0.0485648 -3.79593 -508 2 50.3325 4.25644 9.97415 17.5873 21.0859 -2.62556 -509 2 49.9752 5.63804 9.37548 -18.0954 -29.5198 29.938 -510 3 49.379 6.45094 10.0988 9.73071 -4.74536 -2.58342 -511 4 50.9107 2.76055 8.59957 11.9693 -5.38147 -4.75744 -512 4 49.6509 4.09994 10.8399 -6.9467 2.38538 1.23714 -513 2 51.7744 4.26209 10.561 -12.6039 -21.2869 -0.279481 -514 2 51.8614 5.17465 11.7883 77.4573 -1.34868 -55.222 -515 3 50.9415 5.19238 12.5756 -62.6641 4.37367 45.7089 -516 3 52.9385 5.83334 11.9521 -15.5069 -3.45829 -0.856418 -517 4 52.5513 4.49045 9.80335 -1.41111 7.91559 -3.33271 -518 4 51.9847 3.17606 10.8252 3.56611 15.7947 8.37571 -519 1 50.1134 5.83384 8.05697 5.03044 -3.38183 -24.9476 -520 2 49.6949 7.07302 7.45907 -6.39224 21.6045 -14.6025 -521 2 48.2404 7.19765 6.96855 9.41443 -40.5535 -11.5325 -522 3 47.5994 8.23003 7.09737 -2.60339 17.4007 5.13595 -523 4 50.5903 5.18529 7.39903 -4.72806 0.48988 13.3104 -524 4 49.6568 7.79446 8.28532 6.84483 14.8177 6.93296 -525 2 50.7045 7.63108 6.39006 -19.8247 -9.47824 8.02755 -526 2 50.6996 6.84785 5.08902 -10.629 2.31661 -15.1243 -527 2 51.6586 7.26626 3.9659 -11.3496 43.5825 3.95364 -528 2 53.1317 7.00105 4.2557 32.8208 18.7244 -18.8206 -529 1 53.7683 7.95578 5.14747 -10.6729 7.59108 -11.9454 -530 4 51.7028 7.64661 6.81348 16.7201 -1.45014 11.0251 -531 4 50.4708 8.68128 6.19684 -5.34256 14.1207 -5.41714 -532 4 49.6713 6.8702 4.6668 -0.861277 1.74329 -1.61352 -533 4 50.8688 5.79892 5.31654 5.28855 -19.0543 2.54637 -534 4 51.4741 8.35024 3.65396 8.42695 -12.5098 16.2485 -535 4 51.3565 6.79125 3.04708 -1.5826 -26.0582 -19.3792 -536 4 53.7673 7.0998 3.31183 -20.6632 -9.77681 9.39502 -537 4 53.2972 5.98514 4.64126 3.7215 -8.75629 2.11801 -538 4 53.3251 8.87081 5.17658 4.71004 0.103302 -2.74719 -539 4 54.7439 8.12131 4.95956 10.0262 2.1061 -7.58392 -540 4 53.7752 7.60869 6.06781 -3.05466 -8.65204 35.212 -541 1 47.7159 6.1092 6.3306 31.3529 14.3598 14.0351 -542 2 46.4076 6.11425 5.7591 -25.7668 -19.0326 -13.8071 -543 2 45.4013 5.23171 6.47844 56.1675 -11.9112 16.6864 -544 3 44.23 5.34684 6.24133 -49.2229 2.39302 -4.99484 -545 4 48.3398 5.28969 6.15889 -17.2258 10.451 -1.21207 -546 4 45.9358 7.11624 5.83656 4.3919 7.44058 4.79016 -547 2 46.401 5.6982 4.25555 12.45 -16.5042 -24.1702 -548 2 46.8608 6.82251 3.28226 -4.83626 -15.1342 -13.4955 -549 2 46.0803 8.13881 3.30599 -14.5444 -4.79224 -13.1752 -550 3 44.9716 8.27119 2.67975 10.7775 -8.64163 7.28309 -551 3 46.5691 9.08454 3.95876 4.86602 16.815 8.62941 -552 4 45.3845 5.39013 3.90204 -1.72737 6.76951 8.44594 -553 4 47.0179 4.72632 4.06618 -9.2699 26.8442 8.77601 -554 4 46.8747 6.40942 2.20799 2.04532 8.89503 18.2744 -555 4 47.9008 7.08537 3.56457 7.18737 -1.18981 -5.53646 -556 1 45.8799 4.29222 7.33829 -37.7514 2.20406 -4.61566 -557 2 44.9987 3.41141 8.06424 -3.99299 1.7641 -5.76947 -558 2 44.3276 2.33248 7.21969 -45.1266 -42.7281 27.6017 -559 3 43.411 1.613 7.73718 25.6836 24.6852 -13.962 -560 4 46.8488 4.10168 7.49502 31.0353 -1.43619 1.82022 -561 4 45.5349 2.87862 8.87403 3.80662 2.65181 2.49747 -562 4 44.2009 4.01738 8.56522 2.51171 -3.43938 -1.53795 -563 1 44.7359 2.05713 5.97006 1.92732 3.23614 21.462 -564 2 44.1948 0.978467 5.13766 -26.7101 17.135 -13.9432 -565 2 44.8486 41.5478 5.5025 3.41127 -20.6454 16.5554 -566 3 46.0871 41.4431 5.57675 -14.0525 11.0231 2.35631 -567 4 45.5581 2.59183 5.73006 15.6975 -3.64086 -27.3416 -568 4 43.0338 0.980574 5.28193 28.569 -9.56263 1.83686 -569 2 44.4255 1.37435 3.62453 6.02041 -5.1027 -4.41971 -570 2 43.5303 2.62118 3.29791 4.64703 16.7196 -23.7169 -571 2 44.2051 0.148173 2.67978 -29.1583 2.83252 11.5038 -572 2 43.5747 3.10962 1.83395 1.21002 2.08355 -6.515 -573 4 45.4937 1.66977 3.44724 -0.165314 0.952935 9.41179 -574 4 43.8006 3.52551 3.92139 -2.56937 -12.5949 1.07415 -575 4 42.4611 2.43664 3.46298 -10.2855 -9.14552 12.9963 -576 4 44.5119 0.377143 1.64896 8.27723 -0.881131 -7.54742 -577 4 43.1044 41.7625 2.59144 16.8524 3.81389 6.96191 -578 4 44.7846 41.171 3.05101 -3.46686 1.83863 -12.0461 -579 4 44.5392 3.56167 1.57116 9.55733 8.13116 4.62467 -580 4 42.7809 3.86627 1.57982 6.14378 -4.69974 7.81616 -581 4 43.4757 2.31615 1.08375 -8.22918 -11.6964 -1.57482 -582 1 44.0839 40.4233 5.76821 21.932 -1.5334 -8.86254 -583 2 44.7424 39.1674 6.24443 -3.28027 29.5462 -2.23354 -584 2 45.6232 38.4648 5.15467 16.5957 -3.17533 31.1682 -585 3 45.1655 38.1269 4.0769 -9.06079 2.14789 -9.97198 -586 4 45.3594 39.5074 7.13461 -7.15079 -15.4686 -7.49065 -587 2 43.5266 38.3049 6.70081 12.2837 2.36218 -7.01546 -588 2 42.3912 38.8204 5.83129 -5.25874 0.19697 14.2242 -589 2 42.6515 40.3318 5.90174 -25.8883 17.7161 37.6601 -590 4 43.2615 38.5482 7.76954 6.63706 -13.879 -3.94164 -591 4 43.7406 37.2122 6.50504 -6.24398 7.50926 12.4246 -592 4 41.3856 38.4747 6.1895 5.24712 7.09666 -1.13826 -593 4 42.5101 38.4102 4.83081 -0.0162975 -1.57753 -20.806 -594 4 42.2783 40.7857 6.94925 18.7272 -16.9878 -38.5107 -595 4 42.0764 40.8825 5.13323 2.00122 -0.967094 -8.03005 -596 1 46.8623 38.0021 5.57674 -15.3549 -23.0767 -9.82664 -597 2 47.7161 37.0187 4.84527 -3.88045 42.2808 23.2471 -598 2 47.0384 35.8723 4.15029 10.1677 -9.37304 -39.3599 -599 3 47.4551 35.4743 3.0324 -9.4669 19.846 29.5852 -600 4 48.2252 37.6386 4.0698 7.54977 -11.2433 -2.33648 -601 2 48.6452 36.5035 5.99482 -10.0312 13.1223 -5.95218 -602 2 48.8959 37.7819 6.80046 -4.41071 -5.72741 24.5975 -603 2 47.4918 38.4151 6.80561 23.284 1.3706 -4.72721 -604 4 49.5844 36.0861 5.59811 5.91725 -9.04521 -0.913385 -605 4 48.1158 35.748 6.64071 6.83063 -0.71303 -5.46675 -606 4 49.6383 38.4449 6.34864 7.02588 7.83512 -10.7506 -607 4 49.3019 37.5753 7.85532 -11.9914 1.76609 -18.7023 -608 4 47.544 39.5162 6.85821 3.72706 6.34433 1.60956 -609 4 46.9486 38.0654 7.68542 -11.5693 -5.06488 12.3189 -610 1 46.0019 35.318 4.78064 -26.4221 -3.88232 27.7903 -611 2 45.3025 34.13 4.26579 26.8092 19.3149 11.5505 -612 2 44.4585 34.46 3.02929 16.6723 1.23881 35.6677 -613 3 44.3932 33.6565 2.12406 -6.96945 -13.3218 -23.6344 -614 4 45.6895 35.6839 5.72645 6.17072 -11.3773 -21.4598 -615 4 46.1371 33.4525 3.9443 -9.57056 -4.48549 -9.01935 -616 2 44.5851 33.4333 5.41517 7.28023 -34.3989 -9.31284 -617 2 43.896 32.1478 4.95943 -2.5072 53.7563 23.2534 -618 3 42.6929 32.0377 5.28407 -11.6877 -17.8688 -5.68187 -619 3 44.6212 31.2997 4.42805 15.8429 -32.9345 -13.4225 -620 4 43.8908 34.1037 5.87793 -28.8167 18.0933 10.1447 -621 4 45.2673 33.1449 6.25678 1.67129 3.14432 -6.05002 -622 1 43.9425 35.6996 2.93756 -0.354949 -32.7532 -51.8723 -623 2 43.3733 36.2033 1.70184 -38.6892 -13.1006 14.7431 -624 2 44.3694 36.8017 0.73913 15.0439 4.82349 -39.1461 -625 3 44.0609 36.9601 41.4463 -0.757384 -5.0254 19.6545 -626 4 44.0082 36.3398 3.67638 4.88567 37.3717 42.7902 -627 4 42.8639 35.3314 1.17484 15.8753 7.76257 0.915116 -628 2 42.1931 37.1947 1.98861 35.687 20.598 -23.7763 -629 2 41.116 36.6037 2.88066 -6.28281 10.7168 27.7809 -630 2 39.8788 37.4748 2.97821 -20.6793 -12.2331 -39.8799 -631 3 39.5744 38.0012 4.02693 -4.5695 14.1805 28.3661 -632 1 39.0796 37.534 1.86047 23.989 -9.69865 9.57867 -633 4 41.7899 37.5369 1.00167 -6.59533 -6.76427 4.06671 -634 4 42.6371 38.1477 2.39011 -7.96796 -7.2267 7.32793 -635 4 41.4745 36.4913 3.95075 -0.75248 -0.913082 -13.6466 -636 4 40.7949 35.61 2.55083 -3.16107 -12.1939 -5.02302 -637 4 39.3636 37.1043 0.951835 -4.89499 3.13933 11.6446 -638 4 38.1602 37.9899 1.92801 1.07188 2.17452 -2.18356 -639 1 45.5977 37.1878 1.1702 -15.0402 3.91697 -26.2999 -640 2 46.6124 37.7593 0.269692 0.961344 -25.1749 -6.20454 -641 2 47.1251 36.6298 41.227 -15.6894 27.1972 18.7996 -642 3 47.6617 35.6605 41.7393 11.2436 -21.3221 -9.23089 -643 4 45.7953 37.0706 2.14421 15.4189 2.49224 25.3654 -644 4 46.1246 38.4981 41.5406 -7.74237 14.7139 -7.84953 -645 2 47.8075 38.4099 1.03092 10.1012 15.6193 -18.1996 -646 2 47.4246 39.6903 1.82563 -12.4684 -22.6418 23.6998 -647 2 48.6005 40.4099 2.51691 -17.3417 -7.9082 6.23218 -648 3 49.6876 40.5582 1.97833 4.99301 -0.872474 -9.60266 -649 1 48.339 40.8761 3.75079 34.2245 13.1834 24.2049 -650 4 48.6123 38.7237 0.293834 -9.9427 -4.45455 6.13719 -651 4 48.2879 37.6501 1.66455 2.7768 -3.8165 9.90104 -652 4 46.6323 39.34 2.60232 21.0344 18.1725 -15.5096 -653 4 46.9544 40.4315 1.1644 -6.65764 6.44375 -5.56957 -654 4 47.4103 40.9551 4.17425 -6.86232 -2.61251 -1.04516 -655 4 49.1568 41.2536 4.3255 -23.3959 -10.5461 -18.532 -656 1 47.0132 36.8194 39.8944 4.79393 -10.5252 -5.84263 -657 2 47.6604 36.043 38.8342 19.1375 -30.0942 8.85154 -658 2 48.4687 37.0132 37.9763 6.82075 18.1877 -22.3602 -659 3 47.9595 37.6039 37.0009 8.77071 -9.81154 18.2462 -660 4 46.405 37.5569 39.5258 -2.34297 5.9549 -2.23138 -661 4 48.4229 35.2731 39.2798 -19.3933 25.0679 -4.92238 -662 2 46.6775 35.1997 37.9517 0.490197 24.678 -10.7229 -663 2 46.0672 34.0096 38.7198 -38.9175 -0.700818 10.3629 -664 2 46.8744 32.685 38.9073 -3.26917 9.79703 -36.9848 -665 1 47.7628 32.6295 40.0786 -15.9706 28.2316 14.6984 -666 2 48.51 31.5331 40.3435 -4.63001 14.745 41.8738 -667 1 48.7312 30.5422 39.5064 -7.34995 -4.23697 -9.55446 -668 1 48.9018 31.3819 41.635 -19.9532 28.2508 -37.0556 -669 4 47.1729 34.8887 37.0027 6.80802 -10.5296 7.48075 -670 4 45.9076 35.9114 37.5121 1.10402 -9.8189 16.5264 -671 4 45.0997 33.7597 38.1755 17.1722 -3.36537 -3.11703 -672 4 45.6001 34.3514 39.6854 13.8349 -0.884929 -1.62484 -673 4 47.4022 32.4647 37.9216 2.87405 7.70981 18.3952 -674 4 46.1271 31.862 38.9206 0.553217 -4.0431 12.8995 -675 4 47.6279 33.4362 40.8042 9.43822 -37.2826 -24.9694 -676 4 48.3342 30.5657 38.5603 0.826291 -3.97588 -2.82687 -677 4 49.185 29.675 39.7859 6.04467 -9.07236 4.91997 -678 4 48.5432 32.0104 0.443983 -2.47374 7.53927 7.97734 -679 4 49.3442 30.5519 41.958 17.8055 -32.7958 11.0172 -680 1 49.7507 37.2761 38.36 -27.9891 3.94923 -10.3626 -681 2 50.6372 38.1716 37.6465 6.90802 9.01894 -16.7299 -682 2 51.1009 37.4739 36.3314 6.00851 -0.000986305 0.302592 -683 3 51.4496 36.2941 36.3505 -3.04594 -4.29189 2.8804 -684 4 50.1774 36.6397 39.0138 14.1864 -12.0724 14.4781 -685 4 50.0595 39.0583 37.2837 -1.51256 1.6517 8.14679 -686 2 51.8464 38.6091 38.5553 2.49074 0.426256 -22.3009 -687 2 51.5192 39.49 39.8069 -13.5557 -5.73698 -8.16935 -688 2 52.7888 39.6608 40.6664 -21 22.821 44.9745 -689 2 51.0354 40.8913 39.3667 -19.684 19.0705 -14.0846 -690 4 52.5817 39.1556 37.8894 -7.88883 -2.40182 8.97054 -691 4 52.3725 37.6699 38.8321 2.26719 1.04002 8.03718 -692 4 50.6848 39.0041 40.3963 9.50705 2.70236 -0.692257 -693 4 52.9505 38.8088 41.3668 0.716139 -3.31122 -6.89789 -694 4 52.7117 40.5855 41.3722 -1.5977 -23.2904 -18.3054 -695 4 53.6872 39.819 40.0903 21.6097 1.4026 -14.7648 -696 4 51.7777 41.4333 38.7338 5.73144 0.910017 10.7761 -697 4 50.6933 41.5309 40.2327 12.7628 -5.43827 -4.45399 -698 4 50.1361 40.9136 38.7005 3.06807 -14.6998 5.44273 -699 1 51.1637 38.2069 35.1833 -8.65277 46.2898 44.1617 -700 2 51.553 37.7419 33.8846 1.56046 15.8517 -26.9219 -701 2 52.7972 38.5563 33.3946 6.24297 -42.3048 -4.64985 -702 3 52.8896 39.7642 33.5814 -6.435 17.9384 2.35192 -703 4 50.9569 39.2647 35.262 8.21378 -41.2603 -12.3383 -704 4 51.8027 36.6701 33.8819 4.46523 -10.0245 6.73196 -705 2 50.2986 37.9511 32.9329 -9.17145 -5.64023 18.3882 -706 2 49.0629 37.0889 33.4059 8.5101 -2.50878 -15.0431 -707 2 50.6601 37.6697 31.4816 -9.00198 -6.28682 -34.5666 -708 2 49.2037 35.5513 33.2317 13.0867 -6.63955 11.9256 -709 4 49.9372 39.0006 33.0238 8.27291 6.69816 -3.39278 -710 4 48.1686 37.4323 32.8001 8.11156 -5.69031 9.58675 -711 4 48.8477 37.3684 34.464 -5.28515 -5.82898 -0.156702 -712 4 49.7508 37.5287 30.8047 12.011 -0.0430796 16.0089 -713 4 51.2928 36.7446 31.376 -4.11156 8.47591 0.32382 -714 4 51.1768 38.5507 31.0175 4.51478 -6.96789 5.36543 -715 4 50.1453 35.1216 33.7014 -11.0082 12.206 -5.4516 -716 4 49.2178 35.23 32.1578 -3.59036 3.22922 4.55632 -717 4 48.3665 35.0295 33.7638 0.68062 2.42879 -7.65558 -718 1 53.772 37.8505 32.7005 11.9802 38.3584 -9.99311 -719 2 54.8892 38.4918 31.9453 -18.9337 33.3604 36.4373 -720 2 0.0457823 37.9282 30.5422 -8.24024 2.92716 -24.5162 -721 3 0.594264 36.8423 30.3259 -11.3073 1.50903 5.31397 -722 4 53.7906 36.8495 32.616 -6.44893 -30.0966 2.1434 -723 4 54.5933 39.6185 31.9763 4.67753 -27.1194 -20.6963 -724 2 1.30394 38.4484 32.6241 4.82921 -5.73508 14.5601 -725 2 2.2605 39.423 31.9346 -38.1373 19.2777 23.8899 -726 2 1.83713 40.7771 31.9484 17.1926 2.24265 -1.86924 -727 2 3.4991 39.1266 31.4137 44.2785 -3.28979 -22.8275 -728 2 2.64242 41.8019 31.4282 -29.5168 1.86603 13.0701 -729 2 4.3212 40.1796 30.8558 3.27898 -39.2743 8.81887 -730 2 3.87185 41.4777 30.8782 6.24363 43.3598 -8.15054 -731 4 1.73925 37.4095 32.5315 -6.00214 7.91305 5.68876 -732 4 1.22265 38.7505 33.7444 5.52003 -9.57077 -28.715 -733 4 0.900292 41.0813 32.4345 -2.25415 1.01323 1.36593 -734 4 3.85804 38.0586 31.4239 -1.87041 17.6471 -1.97414 -735 4 2.21075 0.929728 31.5263 16.6224 -11.4708 -8.14622 -736 4 5.34427 40.0148 30.4252 -14.7168 -7.47964 5.81345 -737 4 4.49601 0.410438 30.4759 -4.95559 -13.7664 3.94973 -738 1 54.5157 38.6773 29.5249 -27.0888 35.6462 7.20647 -739 2 54.4663 38.361 28.1069 5.2815 -2.56059 -27.0064 -740 2 53.8105 37.007 27.8285 4.1142 -30.4598 -15.4676 -741 3 54.2925 36.1623 27.0158 -8.84 24.3654 24.6709 -742 4 54.0165 39.6075 29.7175 18.6271 -30.7219 2.56864 -743 4 53.83 39.1099 27.5328 0.819814 -7.88342 20.1611 -744 2 0.845681 38.4599 27.4009 -3.37868 13.1124 0.920574 -745 4 1.3644 39.4179 27.7359 0.635395 -16.0183 -8.53916 -746 4 0.720089 38.4757 26.2839 -0.330424 7.67272 7.0695 -747 4 1.43916 37.5478 27.5772 11.0328 -1.07232 10.5421 -748 1 52.6562 36.7643 28.4919 4.43857 42.1876 29.7882 -749 2 51.8688 35.5726 28.5678 11.3762 10.3615 -9.24037 -750 2 52.1836 34.677 29.7554 -56.6515 -45.7393 26.8579 -751 3 51.2796 33.8674 30.1477 33.9368 21.5747 -13.7315 -752 4 52.2409 37.5914 29.034 7.3769 -32.5773 -16.326 -753 4 50.8037 35.9045 28.6197 0.824464 -11.9292 4.40922 -754 4 51.9818 34.9789 27.6186 -1.74208 2.17118 9.08886 -755 1 53.386 34.609 30.3327 15.9463 0.295407 3.2668 -756 2 53.8702 33.5918 31.2906 -5.336 7.3854 -1.97925 -757 2 53.2724 33.784 32.6972 3.62039 -3.18208 -20.5224 -758 3 53.318 34.8834 33.2435 -3.37109 6.20646 2.08258 -759 4 54.0584 35.341 30.1321 12.3398 9.17802 -3.54281 -760 4 53.5469 32.5903 30.928 0.510164 -2.93777 -2.78072 -761 2 0.450375 33.6574 31.3834 -19.8167 20.6669 9.28695 -762 2 1.1189 33.1041 30.1021 -5.33927 -7.82927 4.13606 -763 2 2.62926 33.3565 30.0201 27.5042 -3.46073 -5.185 -764 2 3.52676 32.4236 30.898 -7.76336 10.6891 3.26174 -765 1 4.93921 32.7908 30.8651 -15.3408 -23.1293 6.29736 -766 4 0.715906 33.1135 32.3077 13.219 -7.49284 0.339296 -767 4 0.711888 34.7596 31.5921 3.25804 -21.2431 -6.20467 -768 4 0.610971 33.6189 29.2485 6.53106 -4.93764 -4.86032 -769 4 0.94328 31.9817 29.9891 -3.372 16.4508 0.497364 -770 4 2.92569 34.3879 30.2717 -10.3735 11.8265 3.32189 -771 4 2.96748 33.277 28.9434 -5.36763 -4.46501 9.75656 -772 4 3.3856 31.3899 30.5364 6.91643 -9.08032 2.48396 -773 4 3.23325 32.4634 31.9813 -4.58699 -1.94284 -9.93441 -774 4 5.35439 32.7181 29.9584 6.30767 5.94328 -10.9381 -775 4 5.52691 32.2429 31.4849 -0.455553 -3.36681 1.56927 -776 4 5.05493 33.7218 31.1915 7.72328 25.1707 0.250012 -777 1 52.7526 32.6794 33.2917 -1.1678 -10.0217 7.16811 -778 2 52.3607 32.6823 34.7156 1.10255 -1.80451 -46.4405 -779 2 53.6298 32.9771 35.466 24.3124 -3.86391 3.03884 -780 3 54.7252 32.4235 35.2212 -23.0397 10.722 4.71956 -781 4 52.6718 31.7771 32.7765 -0.499018 10.5241 3.64804 -782 4 51.648 33.5318 34.8013 -6.43996 -0.39665 8.9378 -783 2 51.7643 31.3153 35.1205 -14.6608 -0.598675 31.299 -784 2 50.4472 31.4454 35.9643 8.77941 -15.5352 -26.1807 -785 2 50.5832 31.9625 37.3651 -2.67912 16.3525 37.5763 -786 3 49.9209 32.9494 37.7433 9.07957 -2.58057 -6.15032 -787 1 51.437 31.3297 38.2211 2.67596 1.57171 0.930055 -788 4 52.5216 30.7277 35.7054 -4.20254 0.0350677 -4.46682 -789 4 51.4878 30.6783 34.2719 3.29993 -4.42069 -15.0162 -790 4 49.9434 30.4567 35.9623 3.78404 -4.63917 10.5702 -791 4 49.6858 32.0412 35.427 2.21977 11.0074 -1.38139 -792 4 51.8063 30.3924 37.9705 2.16328 6.00798 1.3625 -793 4 51.6437 31.7399 39.1747 -6.68696 -10.5036 -22.3596 -794 1 53.5095 33.8962 36.42 -8.20166 25.4414 22.1973 -795 2 54.5747 34.3024 37.3295 -19.3274 -47.2338 19.7644 -796 2 54.3374 33.5175 38.6424 -52.3016 59.5202 -10.0971 -797 3 53.3688 33.7998 39.3891 18.863 -9.21915 -6.06634 -798 4 52.6243 34.4292 36.5865 8.7567 -9.68897 -5.69769 -799 4 0.524888 33.8606 36.995 20.2449 10.0463 -17.6441 -800 2 54.6326 35.7977 37.4305 -12.9517 47.1344 28.5316 -801 2 0.0326923 36.4499 36.0829 -2.43572 -2.53932 -10.8482 -802 2 0.0400304 37.9734 36.2703 -35.7369 26.7596 -9.32276 -803 2 1.42323 35.9178 35.6511 7.48175 21.564 37.2538 -804 4 0.37702 36.205 38.1946 -7.23177 -18.0499 -4.52301 -805 4 53.6103 36.1739 37.8346 22.3749 -7.86488 -15.795 -806 4 54.308 36.1878 35.2646 -5.73883 1.17112 4.65385 -807 4 54.1487 38.389 36.8719 12.989 -15.5349 -14.8375 -808 4 55.0091 38.5546 35.2982 1.66458 -12.2972 11.8538 -809 4 0.898146 38.314 36.8215 26.4509 7.27198 12.604 -810 4 1.38795 34.9003 35.2548 1.76467 -17.1685 3.06812 -811 4 2.15782 36.0461 36.5409 -11.2535 -11.763 -23.0993 -812 4 1.84494 36.4876 34.8385 7.70144 16.3511 -18.9114 -813 1 0.00368541 32.3928 38.6933 60.3495 -72.1401 -12.2197 -814 2 54.849 31.2911 39.6724 -12.054 11.0917 -33.5573 -815 2 0.456178 31.7903 40.9874 10.6429 2.84259 -7.8967 -816 3 1.61925 32.1816 41.0469 -1.25889 2.69502 -0.320895 -817 4 0.771148 32.2113 37.9508 -27.5595 2.34137 31.2634 -818 4 53.7516 31.0568 39.7052 4.35339 2.80588 13.4321 -819 2 0.572301 30.0297 39.0906 18.5839 -9.3637 1.30639 -820 2 0.330271 28.7129 39.848 -4.85336 -14.889 23.6916 -821 2 0.693398 28.6486 41.365 -25.7394 -2.5332 -16.7842 -822 3 54.7394 28.745 0.295995 1.88939 6.38348 7.55667 -823 3 1.88537 28.4667 41.718 12.1129 0.623711 3.73015 -824 4 1.68124 30.2872 39.0755 -12.926 -11.288 -1.20667 -825 4 0.269733 29.7427 38.025 4.32739 20.9521 12.5377 -826 4 0.909417 27.8521 39.409 -5.73579 9.2082 -7.491 -827 4 54.2152 28.4395 39.7334 16.9231 1.48772 2.1114 -828 1 54.6305 31.7883 0.132952 22.8608 6.07746 39.2243 -829 2 54.8576 32.3299 1.48573 -29.3221 31.1311 -21.4901 -830 2 1.17253 32.0229 2.2009 17.6366 -16.111 10.5973 -831 3 1.59057 32.8071 3.07156 -0.674056 0.0659302 -13.788 -832 4 53.659 31.6017 41.9208 -28.5726 -8.3455 -12.917 -833 4 54.8441 33.4787 1.30532 5.06012 -29.8204 14.0187 -834 2 53.6539 32.0394 2.47663 -0.820586 10.1398 -23.6755 -835 2 52.2239 32.3686 2.01123 21.8921 -9.62397 -13.268 -836 3 51.4302 33.0165 2.73635 3.85378 3.64717 10.9914 -837 3 51.8951 32.0293 0.84168 -3.94391 -2.23918 -4.0609 -838 4 53.7898 32.6162 3.39279 8.30271 4.42614 18.4259 -839 4 53.7249 30.9715 2.71423 -6.48233 -12.4206 11.3701 -840 1 1.80027 30.8157 2.00429 -3.41308 17.021 -11.1273 -841 2 3.01391 30.3872 2.67306 -17.4243 6.23421 51.1709 -842 2 4.3573 30.5827 2.00701 -14.1548 15.4243 -63.5733 -843 3 5.42088 30.6338 2.61698 6.51202 -0.211014 15.7475 -844 4 1.38736 30.0831 1.41283 -0.948729 3.54349 -2.60962 -845 4 3.08525 30.9412 3.69277 -1.85342 -9.762 -26.0847 -846 4 2.85031 29.3254 2.98975 11.9317 8.24793 -5.27874 -847 1 4.28888 30.743 0.620497 -12.3621 7.32386 22.4338 -848 2 5.32937 31.2764 41.6512 -13.8663 -29.5394 -9.66616 -849 2 5.57121 32.722 0.10225 -38.3787 16.5244 28.1783 -850 3 4.67744 33.4061 0.685107 26.0808 -18.0695 -15.0621 -851 4 3.36015 30.6914 0.159011 7.3551 0.286523 4.85155 -852 4 6.25759 30.6643 41.7722 1.97617 9.44883 5.82281 -853 2 4.84937 31.1813 40.1487 29.2597 0.863212 8.06821 -854 2 4.69879 29.8019 39.4857 10.4894 -21.0831 -13.1113 -855 2 5.6473 28.6668 39.9936 -13.3021 -14.9024 -16.8737 -856 1 5.27077 28.179 41.3306 -2.96519 4.49812 -11.7353 -857 2 6.06985 28.0105 0.470368 18.4061 -2.74343 27.4639 -858 1 7.404 28.2193 0.415809 -33.9112 -6.97322 0.0250223 -859 1 5.53751 27.6715 1.66745 7.41355 -4.5447 5.6764 -860 4 5.59287 31.7875 39.5584 -6.62026 -5.01092 -0.797873 -861 4 3.90042 31.6963 40.0361 -18.37 16.2558 -2.13315 -862 4 4.87993 29.9347 38.3602 -5.0628 -2.10161 17.6043 -863 4 3.66163 29.4121 39.5629 -5.01534 4.60088 1.06729 -864 4 6.67981 29.0441 39.9161 8.56645 -0.645935 3.00783 -865 4 5.57604 27.7587 39.2774 2.4211 23.1794 17.5601 -866 4 4.26853 28.0084 41.463 -5.17362 0.488763 -0.181308 -867 4 7.82192 28.2777 41.397 19.0269 3.46358 -1.03101 -868 4 7.9555 28.2212 1.28205 9.21585 -1.90571 -0.36079 -869 4 4.50489 27.4888 1.75639 19.7441 2.64647 4.92685 -870 4 6.15841 27.5559 2.53009 -21.7479 0.642981 -21.0512 -871 1 6.76075 33.214 41.6912 19.219 -12.8447 -16.8584 -872 2 7.12868 34.5749 41.8436 1.78261 35.3429 43.0116 -873 2 6.77609 35.3298 40.5962 -19.1975 -45.9981 -46.2181 -874 3 6.48326 34.7082 39.534 6.6414 26.9902 28.4778 -875 4 7.37626 32.7254 41.0127 -5.73863 2.32833 8.30529 -876 4 6.55071 35.0559 0.812315 8.37617 -12.7412 -20.2377 -877 2 8.6392 34.7953 0.238234 19.5739 7.90851 -48.6006 -878 3 9.35353 34.1854 41.0304 -12.8386 -4.95727 8.3137 -879 2 9.11551 34.1669 1.50873 -18.8724 -23.6236 42.9663 -880 4 8.9088 35.8955 0.234805 -6.25165 -9.40588 3.92441 -881 4 10.2786 34.3917 40.988 -0.40493 9.85267 11.4657 -882 4 10.1184 34.4515 1.79035 25.1513 6.04912 0.147779 -883 4 9.07131 33.0605 1.52977 2.37755 -2.72972 -9.56943 -884 4 8.50911 34.4369 2.41136 -0.948376 7.25744 -9.18832 -885 1 6.94474 36.6394 40.6556 -2.44135 26.6434 -23.8261 -886 2 6.9184 37.5467 39.5347 6.69905 -14.1713 -12.8446 -887 2 8.05389 37.1964 38.5245 -27.4859 18.9986 34.7956 -888 3 7.86013 37.2053 37.325 -9.29767 -2.30205 -27.2404 -889 4 7.0965 37.1097 41.5252 4.96112 6.67936 34.6112 -890 4 5.99819 37.3272 38.9586 -4.63141 4.06603 -3.57729 -891 2 6.96111 39.0217 40.0249 7.60343 4.99798 32.9439 -892 2 5.64771 39.5459 40.7503 13.3303 -11.7686 1.87571 -893 2 5.75985 41.0532 41.0609 20.2812 5.99168 -41.4278 -894 2 4.32816 39.2726 39.9704 18.565 3.35099 -29.4893 -895 4 7.21258 39.6788 39.2071 1.58444 12.8598 -26.2647 -896 4 7.87294 39.1662 40.7418 -24.807 -6.41168 -15.2883 -897 4 5.6203 39.0148 41.7319 -7.34537 -3.15131 1.25362 -898 4 4.91646 41.4032 41.6252 -26.0876 7.76092 9.54018 -899 4 5.84653 41.6805 40.0749 -1.44823 -14.0856 28.5036 -900 4 6.60816 41.2866 41.7276 9.52725 -0.69638 -3.08419 -901 4 4.29893 39.8385 38.99 0.215491 -3.12837 12.3269 -902 4 3.42741 39.5069 40.5265 -12.1672 8.54215 8.82184 -903 4 4.17367 38.2217 39.6869 7.24572 -5.84244 0.858739 -904 1 9.22626 36.8637 39.0427 21.4973 3.37181 48.1033 -905 2 10.3674 36.5714 38.2232 -9.10154 -9.23991 0.387697 -906 2 10.2983 35.2598 37.4643 -7.87493 -21.516 -1.82692 -907 3 11.0121 35.0941 36.4546 -10.096 5.18496 3.08952 -908 4 9.43559 37.0753 40.0799 -6.60045 -9.32212 -38.2223 -909 4 10.38 37.3229 37.4195 5.65865 10.6121 -8.5187 -910 2 11.637 36.6734 39.0312 17.5501 -7.37692 6.57672 -911 3 11.6795 35.7227 40.1079 -2.8679 20.1807 -0.19791 -912 4 11.748 37.6704 39.4409 -4.03165 17.0402 13.6797 -913 4 12.5247 36.6276 38.381 6.78129 -14.3562 -2.26856 -914 4 12.1944 34.9922 39.8075 10.5839 -13.8343 -8.97123 -915 1 9.37599 34.317 37.8723 17.0981 22.6825 36.4547 -916 2 9.03961 33.1663 37.0884 -21.5177 -32.5135 -8.8238 -917 2 8.42186 33.6216 35.772 12.1136 -61.8885 -37.6156 -918 3 8.46238 32.81 34.7849 1.32901 29.1307 35.9822 -919 4 8.95542 34.3811 38.853 10.4706 -4.46378 -29.0763 -920 4 9.93142 32.5518 36.7616 2.79547 16.9463 9.21372 -921 2 8.03197 32.1466 37.7484 3.42637 10.6841 -18.9321 -922 2 8.64707 31.2467 38.7916 -6.9544 1.67927 -4.64681 -923 3 8.29676 31.4213 39.9815 6.74685 -6.11142 9.13282 -924 3 9.44706 30.3423 38.4151 3.7337 3.36295 -6.87259 -925 4 7.50152 31.5448 36.9637 8.39997 -2.11551 6.41653 -926 4 7.19405 32.7023 38.1775 -8.25993 10.1263 10.5291 -927 1 7.75009 34.762 35.719 -22.4701 19.7147 -23.1057 -928 2 7.04455 35.3131 34.5484 -10.1936 -29.3849 23.8741 -929 2 7.86233 36.3488 33.8376 -13.0656 11.1044 -41.9487 -930 3 7.58485 36.6599 32.6528 -2.0293 -9.17756 21.4272 -931 4 7.63327 35.3235 36.5488 -2.91413 9.03335 17.0933 -932 4 6.86396 34.4501 33.8456 12.5342 10.3996 -5.08052 -933 2 5.61426 35.844 34.9306 19.6262 -1.52617 -28.8748 -934 2 4.83213 34.6653 35.4025 -10.2806 -24.7237 17.6593 -935 2 4.57558 34.457 36.7787 11.017 23.715 -9.65022 -936 2 4.42364 33.669 34.4835 -0.204454 17.9401 5.69744 -937 2 3.80293 33.3928 37.1817 -18.0339 -16.5573 23.9014 -938 2 3.6203 32.6104 34.8697 -1.59657 -1.57291 16.7967 -939 2 3.28719 32.4878 36.2185 14.3191 25.239 16.785 -940 3 2.42643 31.5967 36.7004 -21.786 -29.0921 6.36516 -941 4 5.08947 36.2348 33.9913 8.47084 3.13833 18.0937 -942 4 5.68856 36.6154 35.7126 -3.45102 11.3715 1.65586 -943 4 4.93536 35.177 37.5545 -2.85956 -5.82375 -8.46254 -944 4 4.68581 33.7849 33.4351 -1.13786 -0.0334624 -10.731 -945 4 3.5508 33.3312 38.3093 3.7661 -3.16504 -32.8067 -946 4 3.21561 31.8879 34.1609 -1.14089 -4.88721 -7.16666 -947 4 2.07822 31.0058 36.0335 4.80509 5.07869 -1.12919 -948 1 8.89276 36.9109 34.4697 3.08208 2.61779 2.42454 -949 2 9.71554 37.9518 33.9536 6.78836 41.9101 -7.41895 -950 2 8.87118 39.1918 33.5791 -2.83098 -3.29658 16.5328 -951 3 9.07345 39.7706 32.5156 6.00915 0.294316 2.75033 -952 4 9.0886 36.6939 35.4314 3.3626 -5.13227 22.9354 -953 4 10.4005 38.393 34.7625 -11.752 -18.5108 -5.62727 -954 2 10.5665 37.5273 32.7526 17.9231 -22.0125 -23.4044 -955 2 11.7038 38.502 32.4536 -20.96 9.74481 -37.2535 -956 3 11.6878 39.1949 31.3977 0.540028 -8.54016 25.273 -957 1 12.687 38.5377 33.3475 38.0496 20.2334 23.5086 -958 4 9.97947 37.4403 31.7814 1.01798 2.165 18.3599 -959 4 11.0193 36.505 32.8955 -2.74071 8.1052 0.988861 -960 4 12.6531 37.864 34.1655 7.32082 17.5294 -13.3715 -961 4 13.4532 39.3055 33.2787 -30.6572 -33.7139 4.421 -962 1 7.93658 39.5767 34.4996 32.6534 -23.6413 -9.43678 -963 2 7.20273 40.8089 34.5743 -2.74612 21.1773 -15.346 -964 2 8.21766 41.8982 34.9197 -3.45605 -13.7782 10.2915 -965 3 8.98784 41.7778 35.8832 -3.40272 -3.46005 -6.10842 -966 4 7.93188 38.9898 35.3424 -7.46187 6.56739 7.86278 -967 4 6.79415 41.087 33.5295 1.97546 -9.26453 20.6229 -968 2 6.06472 40.6271 35.6481 -5.08297 -2.08213 -22.9213 -969 2 4.90833 39.9858 34.8157 -12.6977 -10.7104 -3.72739 -970 2 5.64222 41.9226 36.403 -2.05312 -2.0705 -19.9517 -971 2 3.84054 39.2603 35.6406 -0.0147652 -3.33058 30.6695 -972 4 6.3943 39.8459 36.3734 2.85979 7.06395 10.3389 -973 4 5.33061 39.1839 34.1245 -4.62997 12.2623 4.99778 -974 4 4.37584 40.73 34.1591 8.26763 -2.20969 2.2716 -975 4 4.92993 41.6478 37.2106 -0.0042749 6.0371 4.19307 -976 4 5.15795 0.778755 35.7389 -1.27911 -10.984 2.34352 -977 4 6.51935 0.549814 36.8166 0.412823 -4.00159 10.9885 -978 4 3.21428 39.9846 36.2492 8.55414 -9.22464 -7.99451 -979 4 4.28582 38.4972 36.3757 -6.36125 15.4526 -14.7269 -980 4 3.14756 38.696 34.9847 -1.95473 -0.292674 -1.44435 -981 1 8.25206 1.08297 34.1638 31.3741 38.5442 9.59718 -982 2 9.18814 2.19093 34.4552 -11.7272 -14.356 -0.722089 -983 2 8.45749 3.48131 34.8023 4.76941 7.21795 3.77261 -984 3 7.24176 3.59586 34.6101 4.23254 1.41941 3.46139 -985 4 7.75397 1.25241 33.3001 -16.6469 -12.6897 -14.3012 -986 4 9.75614 1.90919 35.3591 7.11639 4.99627 7.91164 -987 2 10.1452 2.40125 33.2642 -9.36205 3.53781 1.41258 -988 2 11.145 1.26701 33.0621 15.3724 -18.5317 -10.2549 -989 2 12.3408 1.2215 34.0193 -34.6799 -20.8737 -4.25674 -990 3 13.4283 1.6066 33.6334 28.2263 9.73281 -4.88467 -991 1 12.1185 0.540183 35.1633 28.8031 2.35628 29.4382 -992 4 10.7148 3.34616 33.3936 1.59432 0.534457 -2.79864 -993 4 9.49714 2.55965 32.3759 6.01649 -0.268224 -5.10448 -994 4 11.6127 1.34439 32.0577 -0.769775 9.57011 -1.56393 -995 4 10.6933 0.251936 32.9886 -5.52334 3.35231 7.85959 -996 4 11.2139 0.219277 35.5156 -12.526 -0.0546681 -6.86711 -997 4 12.9016 0.455342 35.8573 -9.00019 3.15098 -17.6728 -998 1 9.24699 4.48326 35.2867 7.50516 -22.9453 -9.87373 -999 2 8.79457 5.81029 35.6553 19.4094 -0.44208 23.4194 -1000 2 7.94193 6.35186 34.5098 -28.0836 13.7832 22.6841 -1001 3 8.26577 6.15625 33.3485 3.32417 -1.59684 -17.5239 -1002 4 10.2626 4.25405 35.3107 -8.01304 16.2193 5.9612 -1003 4 8.1894 5.68577 36.5846 -11.6257 -0.00282829 -7.04897 -1004 2 9.97767 6.74716 36.1433 -23.7266 14.1696 -20.2452 -1005 2 11.1395 6.93836 35.1562 2.17384 -4.68321 -25.171 -1006 2 12.442 7.40754 35.8023 6.89417 23.6707 25.6501 -1007 2 12.3585 8.87197 36.3546 -17.7601 7.18701 6.16378 -1008 1 13.652 9.40345 36.7619 -5.05233 -10.0697 25.3038 -1009 4 10.4674 6.41708 37.0624 -6.17454 -12.8958 16.6295 -1010 4 9.46609 7.72624 36.4439 19.6997 -12.4825 -9.52898 -1011 4 10.8586 7.67723 34.3661 -2.31205 -2.27426 2.47252 -1012 4 11.3956 5.98923 34.5935 -8.15618 9.36142 7.97067 -1013 4 13.285 7.3766 35.0989 4.02069 -2.74272 -14.2107 -1014 4 12.7725 6.74228 36.6382 -4.94702 -0.810609 -4.3443 -1015 4 11.6162 8.97546 37.2517 21.5709 -5.37851 -23.6156 -1016 4 11.9848 9.59279 35.5592 1.32622 -13.234 7.43529 -1017 4 13.5097 10.3531 37.0548 1.1249 12.5728 4.15723 -1018 4 14.3076 9.4933 35.9914 2.38442 -5.54985 1.16984 -1019 4 14.0989 8.9471 37.5942 -8.28554 10.0467 -28.7492 -1020 1 6.74258 6.95961 34.8453 13.8439 -7.08515 -31.5666 -1021 2 5.70412 7.47847 33.9372 22.4359 17.1833 28.8896 -1022 2 4.73468 6.47268 33.3926 -37.2702 -51.3286 -21.7325 -1023 3 3.66084 6.82477 32.8505 20.0183 9.28716 8.38675 -1024 4 6.50761 7.12516 35.8163 -0.959582 1.3178 20.8718 -1025 4 5.07512 8.17388 34.5809 1.06569 -12.1955 -8.24357 -1026 2 6.27511 8.35576 32.8097 23.4106 2.51452 -13.5767 -1027 2 6.97942 9.67377 33.2004 -16.9954 14.0421 10.4255 -1028 2 6.10535 10.8129 33.826 12.866 -26.3315 -27.4761 -1029 3 5.32563 11.4369 33.048 -2.57309 4.89094 -0.177716 -1030 3 6.28787 11.1355 35.0235 5.56298 3.82152 16.5631 -1031 4 5.49496 8.55729 32.0786 -16.2509 9.70978 -5.42728 -1032 4 7.00993 7.79082 32.1666 -6.62982 -1.98309 13.432 -1033 4 7.44051 10.1227 32.2823 5.63402 -3.39012 2.91122 -1034 4 7.79617 9.4262 33.9151 4.88029 0.56984 -5.69246 -1035 1 4.9985 5.11713 33.407 24.659 21.8647 21.6253 -1036 2 4.05493 4.11234 32.9569 -19.5991 11.2557 -30.6753 -1037 2 2.66349 4.36425 33.564 5.77052 11.5327 33.941 -1038 3 2.61183 4.63212 34.7889 -10.6254 -2.1096 -24.9185 -1039 4 5.90798 4.72579 33.7623 -18.8375 16.0079 -6.75199 -1040 4 3.94963 4.2178 31.8123 4.18537 -9.18741 21.4869 -1041 2 4.52113 2.73738 33.4375 8.25229 -17.2331 29.0433 -1042 3 5.75234 2.38881 32.7881 -21.5054 -2.62865 -12.7372 -1043 4 3.76903 1.95227 33.2696 -3.85539 -5.9091 -13.5606 -1044 4 4.62925 2.69715 34.589 6.20333 6.93314 -25.3828 -1045 4 6.43526 2.61043 33.3995 7.46021 4.72267 11.925 -1046 1 1.55191 4.21884 32.8032 -14.0425 -5.15851 -21.6842 -1047 2 0.161375 4.25438 33.2368 -9.40026 13.4655 23.096 -1048 2 54.692 2.80115 33.3646 18.1492 -1.83923 -37.1888 -1049 3 54.7885 2.04564 32.3679 -9.76904 2.34815 11.9713 -1050 4 1.58614 3.87283 31.8209 11.2241 6.42129 12.946 -1051 4 0.0932821 4.78062 34.2407 6.57702 -9.00044 -6.29593 -1052 2 54.1421 5.03026 32.3092 -30.8516 -27.3257 32.8914 -1053 3 54.4529 6.38645 32.3432 43.6526 11.7784 12.1317 -1054 2 52.6693 5.00292 32.8811 18.0931 2.75777 -15.9968 -1055 4 54.1554 4.62002 31.3044 4.18983 -2.87474 -22.2473 -1056 4 53.8639 6.90955 31.8518 -25.2917 13.9269 -18.693 -1057 4 52.66 5.46781 33.8932 -7.48107 5.39969 -2.18241 -1058 4 52.249 3.98991 33.0062 0.231344 -5.48034 -3.27193 -1059 4 51.9963 5.5356 32.1423 1.66512 -1.40627 14.088 -1060 1 54.1705 2.41097 34.5199 1.80418 26.5965 31.5441 -1061 2 53.4771 1.1604 34.7223 -23.5881 -17.4143 30.2256 -1062 2 51.9672 1.43692 34.4286 45.4706 11.6959 19.6168 -1063 3 51.5098 2.51334 34.8139 -14.0548 -1.70012 -4.22959 -1064 4 54.1449 3.13072 35.3168 -2.84084 -28.6208 -21.3152 -1065 4 53.8073 0.317305 34.0552 7.54144 10.0832 -0.542806 -1066 2 53.6466 0.727247 36.2732 15.0023 -0.977243 -19.0787 -1067 2 0.11045 0.778115 36.8855 -3.47233 23.3808 -12.4462 -1068 2 0.174657 0.0352411 38.2454 9.71436 -6.65086 -1.81426 -1069 2 1.19132 0.222888 35.8995 6.11034 15.7938 3.95568 -1070 4 53.2393 41.6189 36.352 -4.11551 -11.0062 3.39296 -1071 4 53.0266 1.35722 36.9407 -10.5209 2.31976 -3.99924 -1072 4 0.276909 1.89779 37.0745 11.3679 -17.77 -1.06189 -1073 4 54.361 0.442618 38.9125 4.10216 -8.97134 2.26246 -1074 4 1.16474 0.174268 38.7716 -10.2453 4.64912 -5.91146 -1075 4 0.0894693 40.827 38.1128 -8.07449 10.5575 2.47406 -1076 4 2.18017 0.0911741 36.3628 0.498668 -8.86502 15.8712 -1077 4 1.51082 0.946112 35.1046 -21.6742 -5.82018 -4.77892 -1078 4 0.87048 41.1455 35.5035 3.84873 -0.316194 -7.96637 -1079 1 51.2572 0.510776 33.7869 -35.0849 -22.21 -18.422 -1080 2 49.7991 0.651464 33.5457 -7.89552 -1.42073 2.85742 -1081 2 49.1064 41.7127 34.6422 20.8091 24.7993 -30.4476 -1082 3 49.3211 40.5176 34.6928 0.936017 -16.9834 6.81615 -1083 4 51.5685 41.4333 33.6514 6.90564 11.6478 3.53197 -1084 4 49.4699 1.73569 33.6536 7.71362 -9.58165 1.5915 -1085 2 49.2914 0.124722 32.1435 -1.6477 0.542595 21.3952 -1086 2 49.5957 1.07684 31.016 -40.6033 -15.585 26.437 -1087 1 48.7294 1.99918 30.4836 -27.6566 13.4748 -4.54446 -1088 2 50.7297 1.21695 30.3262 36.7247 10.1326 -33.1818 -1089 2 49.2902 2.59089 29.4013 15.6758 12.8861 -16.3634 -1090 1 50.5605 2.13547 29.3267 -27.6128 -3.77706 23.4645 -1091 4 48.1729 41.8384 32.2733 14.3125 6.04861 -12.1255 -1092 4 49.7214 41.0254 31.9181 -0.443629 4.48635 2.11286 -1093 4 47.7408 2.2006 30.8029 20.1006 -6.4749 -2.25561 -1094 4 51.6449 0.698065 30.4056 15.084 -12.5894 5.57169 -1095 4 48.9104 3.2954 28.6425 -5.47018 -10.6135 19.6435 -1096 4 51.2563 2.40703 28.6421 12.9903 7.46191 -13.5301 -1097 1 48.3611 0.457254 35.523 -13.4783 35.8963 4.98689 -1098 2 47.6684 41.7265 36.6028 -12.609 2.82517 16.7739 -1099 2 46.2613 41.336 36.1362 14.2498 9.86212 -6.63619 -1100 3 45.3696 0.249228 35.9008 11.2544 -8.11188 8.40093 -1101 4 48.1527 1.47601 35.3837 2.04907 -15.0615 5.33592 -1102 4 48.2568 40.8085 36.8471 -2.89667 -2.02658 5.80089 -1103 2 47.5596 0.692305 37.8969 5.07609 12.8861 -15.4572 -1104 2 46.7247 0.067171 39.0652 -23.3887 -7.36646 -24.3057 -1105 2 47.033 40.4837 39.4166 -14.2982 16.8046 -18.6717 -1106 2 46.9311 0.907751 40.3269 20.2628 20.9695 31.7148 -1107 4 47.0803 1.72619 37.5586 18.4264 -28.4903 17.3716 -1108 4 48.6288 0.838001 38.2574 -15.841 5.68773 -4.62102 -1109 4 45.6307 0.107149 38.6982 15.4635 0.946246 17.2142 -1110 4 48.0197 40.3992 39.8616 17.8935 -6.94949 10.1905 -1111 4 47.0012 39.8155 38.524 1.84183 3.03864 3.36861 -1112 4 46.2605 40.0937 40.1174 3.5183 -0.242765 2.2201 -1113 4 48.0596 1.05972 40.5786 -27.9597 -7.64804 -5.61245 -1114 4 46.4366 0.492644 41.2461 4.13191 -4.52617 -8.48469 -1115 4 46.5029 1.93558 40.2678 1.33797 -2.98423 -8.86627 -1116 1 46.1363 40.0225 35.9719 -11.8784 -48.163 0.632693 -1117 2 44.9067 39.2611 35.7716 22.3959 0.0668878 -14.2888 -1118 2 44.4049 38.8629 37.1725 -35.2322 11.6067 -22.5418 -1119 3 45.1472 38.486 38.0617 14.0918 -2.68919 9.70234 -1120 4 46.908 39.3425 36.1226 1.34088 13.782 2.29065 -1121 4 44.2497 39.8817 35.1331 -17.245 4.97255 12.4072 -1122 2 45.2366 37.985 34.8925 -4.99104 -6.23114 -9.17669 -1123 2 44.0069 37.0072 34.8313 5.26574 11.342 7.98842 -1124 2 45.6195 38.3915 33.4226 -3.76358 -20.0352 6.70883 -1125 4 46.1177 37.4383 35.3134 -3.76426 -1.15462 7.05426 -1126 4 43.5316 36.9313 35.8696 0.358942 -6.34703 -24.4349 -1127 4 44.3242 35.9956 34.5249 4.20531 -7.16171 2.34616 -1128 4 43.2753 37.3126 34.0403 -3.87397 3.42825 10.5933 -1129 4 46.6384 38.8467 33.4221 -3.79452 2.69366 -2.61982 -1130 4 44.9004 39.1304 33.0043 0.823619 -0.608417 -3.73086 -1131 4 45.6564 37.4663 32.7381 0.0287792 19.4258 11.3413 -1132 1 43.0561 38.9062 37.36 16.7964 -0.846157 38.4014 -1133 2 42.4272 38.5172 38.6279 -14.5421 -18.7427 13.0828 -1134 2 41.8753 37.0763 38.5124 -8.78692 12.5845 -64.2445 -1135 3 41.466 36.6885 37.3717 6.29707 6.96761 32.6735 -1136 4 42.3774 39.0214 36.6331 -15.2734 7.16413 -28.2079 -1137 4 43.1919 38.4467 39.4108 16.1917 0.0561369 8.47296 -1138 2 41.3404 39.5151 39.1514 -18.2527 2.1619 5.40726 -1139 2 42.0205 40.8503 39.6333 -29.5812 13.2835 -20.5362 -1140 2 41.0689 0.171231 39.4112 30.2059 17.4331 -9.29433 -1141 2 42.4678 40.816 41.1078 15.9246 -23.8206 -10.1516 -1142 4 40.688 39.0893 39.9799 16.7303 0.907162 -6.07322 -1143 4 40.5588 39.6983 38.3606 15.4269 0.857054 0.728379 -1144 4 42.8535 41.0549 38.9416 17.5291 -0.3509 1.61726 -1145 4 41.6271 1.1561 39.6676 -14.9721 -22.7636 -0.520954 -1146 4 40.1564 0.111331 40.0029 -13.6089 -0.269988 10.9836 -1147 4 40.76 0.320829 38.3386 1.94315 -8.64923 8.74761 -1148 4 41.6626 40.4848 41.7802 -9.99726 5.60483 6.07701 -1149 4 42.8258 41.8281 41.4135 4.90552 -5.57863 6.49728 -1150 4 43.2679 40.0127 41.241 -4.54696 19.1865 -0.92221 -1151 1 41.8233 36.2733 39.5754 -3.61756 -11.0936 16.9633 -1152 2 41.1922 34.957 39.6399 -10.4088 -17.6704 -50.7121 -1153 2 39.8412 35.0841 40.3193 -0.437683 4.39576 10.763 -1154 3 39.8144 35.4746 41.4864 -9.76 5.96233 -2.547 -1155 4 42.2323 36.5766 40.4577 6.86651 4.46574 10.4638 -1156 4 40.9934 34.6386 38.4963 8.65196 -1.15376 42.0164 -1157 2 42.0562 33.8903 40.4247 20.8855 33.0106 -9.02378 -1158 2 41.3005 32.6543 41 38.0556 15.2529 -12.1112 -1159 2 42.2217 31.3951 41.1067 -29.8496 -30.3433 -13.4218 -1160 1 43.3285 31.549 0.111927 13.7517 39.8644 23.5527 -1161 2 44.3839 30.7268 0.286736 21.6234 19.2182 17.9174 -1162 1 44.681 29.6113 41.5428 -25.8767 -16.3024 -25.7307 -1163 1 45.3493 31.1499 1.13058 -39.3833 23.49 -6.35183 -1164 4 42.617 34.5166 41.192 -12.3652 -23.3828 3.531 -1165 4 42.8948 33.5841 39.7601 -4.64767 -6.80459 -5.17496 -1166 4 40.4819 32.4474 40.3056 -13.8786 -11.9041 -4.8646 -1167 4 40.8645 32.9834 0.0421702 -8.7777 -8.2778 13.4879 -1168 4 42.5872 31.067 40.0872 -0.36901 12.0823 9.30135 -1169 4 41.553 30.5032 41.4129 16.6518 20.7036 2.18161 -1170 4 43.3615 32.497 0.627799 -1.11121 -36.4642 -14.6418 -1171 4 44.0326 29.3067 40.7749 11.9664 -0.606259 12.9296 -1172 4 45.4908 28.9966 41.7635 -4.5997 7.04477 0.652143 -1173 4 45.2947 32.0222 1.6989 -3.32167 -9.1207 -8.17541 -1174 4 46.1369 30.5772 1.3332 29.28 -20.6173 7.21336 -1175 1 38.7318 34.7203 39.6307 -5.56998 -4.40152 -32.2775 -1176 2 37.3555 34.7738 40.1542 17.1032 1.0045 -6.37855 -1177 2 37.2353 33.667 41.1913 -33.3614 37.0741 40.0449 -1178 3 37.7005 32.5636 40.9891 18.731 -32.0974 -3.65368 -1179 4 38.8335 34.3404 38.6486 -6.51334 12.5121 23.5529 -1180 4 37.2672 35.7762 40.6273 -9.086 1.46109 5.84779 -1181 2 36.2453 34.5638 39.0845 -6.93832 -9.37108 -7.97374 -1182 2 36.1701 35.614 37.9414 8.91404 15.2365 -6.3275 -1183 2 35.3527 35.0344 36.7472 39.8054 8.21108 -27.9 -1184 2 35.4841 36.9314 38.4139 -18.287 13.7727 -16.8718 -1185 4 35.232 34.5024 39.5744 7.45292 -0.257102 0.0904576 -1186 4 36.3852 33.5433 38.6164 0.781265 7.17557 6.89015 -1187 4 37.2115 35.9047 37.5843 -11.2451 -10.8797 5.10717 -1188 4 35.5662 35.6385 35.778 -16.1675 -5.48794 25.897 -1189 4 34.291 34.967 37.0013 -15.7304 -0.876038 -4.35202 -1190 4 35.7074 34.0135 36.4456 -4.10332 3.28733 9.08934 -1191 4 35.4655 37.7439 37.5577 -4.97646 -27.0735 23.6494 -1192 4 36.0148 37.4196 39.237 12.1669 1.46201 8.99598 -1193 4 34.4369 36.7462 38.8365 16.8945 3.16641 -16.172 -1194 1 36.5334 33.9935 0.435925 10.1465 7.38421 -15.9691 -1195 2 36.4058 33.2568 1.6875 16.4821 -29.3274 -13.0782 -1196 2 35.1468 33.6833 2.42741 -3.52585 26.4938 2.22063 -1197 3 34.7699 34.8785 2.50349 9.50092 -20.8144 -9.83338 -1198 4 35.9506 34.8486 0.439937 7.33038 -6.12466 -5.51472 -1199 4 36.3499 32.1247 1.42412 1.62075 26.2077 7.36918 -1200 2 37.675 33.5505 2.58336 -0.681506 -6.35683 7.58589 -1201 2 37.7854 32.6927 3.8625 18.6921 -17.668 32.0141 -1202 2 39.0575 32.9332 4.76873 14.2724 -20.5826 -30.9069 -1203 1 39.1289 34.2491 5.33109 11.0713 19.2422 13.5273 -1204 2 40.0441 34.6938 6.2528 -38.5124 5.77538 -21.346 -1205 1 41.0523 34.0015 6.75388 -9.3068 -30.315 -40.8639 -1206 1 39.7573 35.8959 6.75045 4.65044 -37.6482 -19.533 -1207 4 37.7117 34.6025 2.94212 -4.78803 6.98284 -11.1897 -1208 4 38.6033 33.3783 1.98429 -1.50456 2.19712 -0.683264 -1209 4 37.8193 31.5994 3.65006 -4.42508 0.799529 -11.9295 -1210 4 36.9318 32.7949 4.56147 -11.5542 5.52665 -5.70323 -1211 4 39.9727 32.6563 4.13477 -10.3426 12.9457 13.0222 -1212 4 39.0991 32.232 5.62646 -6.41615 -9.9444 -1.6393 -1213 4 38.3112 34.8566 5.12728 9.08197 -0.1797 3.06874 -1214 4 41.338 33.0965 6.26824 1.29043 26.2885 21.8424 -1215 4 41.5567 34.3995 7.53172 18.6054 -2.34736 15.9895 -1216 4 38.9283 36.4191 6.51463 -17.6749 8.57537 -7.4588 -1217 4 40.3535 36.2619 7.44459 24.2502 25.7988 36.1589 -1218 1 34.4423 32.7029 2.99518 -5.91218 -18.2551 8.17758 -1219 2 33.2643 32.9205 3.78866 2.14491 3.18155 15.0212 -1220 2 32.3114 31.74 3.93685 27.6029 1.93064 -50.2862 -1221 3 31.6521 31.6162 4.95167 -20.1995 -6.42992 23.3772 -1222 4 34.7506 31.7123 2.9878 2.11082 4.57648 -1.08475 -1223 4 33.5885 33.2179 4.82725 -4.56531 -3.45872 -11.3922 -1224 4 32.6993 33.791 3.40271 -6.19117 1.50996 -1.33542 -1225 1 32.2733 30.8792 2.86255 -3.44833 -0.807911 26.2314 -1226 2 31.5067 29.6456 2.87911 -22.6819 -12.0155 6.38652 -1227 2 32.0275 28.5204 1.99364 -17.4826 -15.7648 -26.1521 -1228 3 31.24 27.9052 1.1757 18.2868 13.9435 17.0259 -1229 4 32.9257 31.0189 2.07167 -6.99587 -10.4877 -2.31778 -1230 4 31.4409 29.1882 3.92659 1.7726 14.0477 -11.6562 -1231 4 30.4172 29.8482 2.57519 20.7941 0.876843 7.98191 -1232 3 33.2432 28.1769 2.02662 6.75216 10.2675 5.6015 -1233 6 29.6689 33.0345 2.6027 6.39732 3.7635 -6.59735 -1234 4 28.7656 33.0857 2.95028 -0.371973 -14.4593 -6.85361 -1235 4 29.8153 32.1814 2.14015 -8.59972 11.6466 4.8732 -1236 6 1.91326 24.7635 28.0772 5.65317 -6.35183 16.4854 -1237 4 1.01929 24.4316 28.2568 3.94453 1.46201 -0.938269 -1238 4 2.46517 24.4471 28.8255 -6.59296 2.11781 -11.8027 -1239 6 8.98979 35.4216 7.06427 2.13264 0.908259 -3.07356 -1240 4 8.22375 36.0041 6.95701 -0.608539 -3.26387 0.365744 -1241 4 9.74616 35.991 6.87666 4.70766 2.91314 -0.442423 -1242 6 37.9357 35.2342 23.5273 -23.102 9.18642 19.8247 -1243 4 37.5041 35.2968 22.6705 0.513901 -3.82007 -8.89977 -1244 4 38.8432 35.0218 23.4038 20.8563 -8.17935 -11.4372 -1245 6 11.3793 34.6137 20.3253 14.1507 4.32837 -4.20952 -1246 4 10.4755 34.624 20.6003 -22.0831 6.77293 1.73618 -1247 4 11.7264 33.9016 20.8561 13.9299 -11.0914 4.04985 -1248 6 3.06607 13.1144 13.5167 22.577 18.8722 18.6067 -1249 4 2.20388 12.8262 13.8046 -7.02328 -4.57126 0.810516 -1250 4 3.32154 13.8092 14.1761 -2.44089 -14.0351 -15.8923 -1251 6 9.17443 22.3777 24.8954 -7.42914 3.56866 8.74917 -1252 4 9.07626 22.0242 24.0039 2.26474 -2.4656 -3.7019 -1253 4 8.26912 22.4958 25.2295 3.15193 -1.43545 -3.27774 -1254 6 31.1464 36.1236 7.45234 10.6607 -18.1227 -24.2194 -1255 4 30.9334 35.2222 7.12747 -5.34615 12.6105 12.538 -1256 4 31.8314 36.3443 6.79825 -5.43643 8.62165 8.26122 -1257 6 20.3227 0.172698 30.1419 10.3105 -3.05703 7.76208 -1258 4 20.0388 1.0684 29.8874 5.3247 -3.32009 0.781739 -1259 4 21.2583 0.228399 30.4322 -11.2768 6.47679 -5.28094 -1260 6 32.6859 3.01778 5.15829 -10.6028 -19.0303 43.6625 -1261 4 32.0356 2.3058 5.02019 7.54008 9.83835 -8.28794 -1262 4 32.7128 3.00557 6.15578 5.12118 6.62375 -23.7252 -1263 6 26.2374 8.27856 11.5971 17.869 0.788073 20.0593 -1264 4 26.2346 7.39991 12.0216 -0.142457 7.42091 -4.28305 -1265 4 26.8978 8.79254 12.1302 -17.5189 -15.6641 -18.5798 -1266 6 1.09614 20.2561 0.875192 -22.9747 0.467748 19.1373 -1267 4 0.851949 19.3199 1.10255 19.4844 20.3298 -11.3195 -1268 4 1.85437 20.3448 0.297385 12.1513 -16.76 -9.59627 -1269 6 29.1514 22.9126 1.42851 -3.57267 15.5796 12.2113 -1270 4 28.6966 23.7416 1.67141 5.52941 -12.1705 -9.88265 -1271 4 29.6634 22.7027 2.22543 0.165437 -2.26551 -2.85175 -1272 6 34.1399 34.826 6.47271 -4.00425 12.5535 -7.93856 -1273 4 34.8635 34.3401 6.10458 13.259 -3.54932 -9.87122 -1274 4 33.9387 34.3337 7.25184 -8.28913 -2.66912 16.7304 -1275 6 25.1643 37.1931 26.5228 17.2229 -22.0393 -23.1844 -1276 4 24.6935 37.7676 27.1042 -4.31343 22.2846 18.4719 -1277 4 26.0117 37.6203 26.271 -7.79876 5.52479 6.28113 -1278 6 14.5333 22.2337 15.6719 -21.8235 -40.5779 4.16881 -1279 4 14.0435 21.3187 15.7268 23.5152 50.9834 -4.51283 -1280 4 14.2451 22.7392 14.8947 -1.224 -10.8945 3.63574 -1281 6 2.86145 5.86342 4.09514 -12.0928 12.5672 -7.55007 -1282 4 3.31871 5.53612 4.87755 -0.114002 3.3263 11.1441 -1283 4 2.36891 6.69134 4.30817 11.5092 -15.7361 4.93451 -1284 6 27.6072 26.7133 22.7037 11.3111 -21.4893 35.9413 -1285 4 26.8221 26.1673 22.7712 -7.10606 -4.70529 -2.97044 -1286 4 27.5145 27.2572 21.9514 -10.0855 20.8317 -32.7258 -1287 6 17.7799 0.609907 22.4001 -5.17757 10.6635 4.04288 -1288 4 17.0763 0.657064 23.0885 11.5181 4.04392 -9.91171 -1289 4 18.0806 1.5364 22.261 -7.85301 -10.5281 2.59652 -1290 6 8.08893 9.42761 10.5595 3.55537 5.25916 40.324 -1291 4 7.89361 10.322 10.3179 -9.19974 15.7377 -19.3495 -1292 4 8.16563 9.56196 11.5399 2.2102 -21.2534 -20.7584 -1293 6 15.3508 8.71886 30.755 5.09068 -14.416 21.7005 -1294 4 15.721 8.98141 29.9127 -5.17651 10.4904 -11.2194 -1295 4 14.5411 9.19598 30.997 6.64715 3.62724 -9.30987 -1296 6 11.0273 17.2714 37.5546 -8.62993 4.63856 -3.16721 -1297 4 10.646 18.1523 37.5049 13.3861 11.3255 -4.88271 -1298 4 10.2437 16.8378 37.8681 -2.55755 -24.0409 7.53141 -1299 6 42.0954 25.1585 20.3881 14.6842 1.84925 -24.6227 -1300 4 41.6997 25.8318 19.7943 -2.16553 -3.48259 16.6789 -1301 4 41.6994 25.1952 21.2528 -9.02961 7.39914 10.888 -1302 6 25.8656 4.70522 33.8434 4.94337 -17.9304 30.0995 -1303 4 25.7948 4.41246 32.9437 -1.56424 4.53154 -20.9619 -1304 4 25.7821 5.65919 33.9019 -2.93726 10.638 -9.31877 -1305 6 28.7565 10.7943 24.343 5.31048 -5.66707 -17.5237 -1306 4 29.0395 10.691 25.2776 6.61806 -8.7001 -20.887 -1307 4 29.3174 10.2678 23.7025 -8.86987 6.64124 26.5787 -1308 6 5.00601 41.813 11.1 6.11697 -35.3303 28.6791 -1309 4 5.97939 41.6679 11.0741 -12.7816 8.03831 -2.02432 -1310 4 4.68345 41.1078 11.7429 5.5471 25.1349 -25.8779 -1311 6 51.7607 12.785 30.1531 41.9873 7.8243 6.58168 -1312 4 51.5044 13.1989 29.3224 -3.76645 3.26875 -7.63234 -1313 4 52.7548 12.9452 30.2104 -29.821 -7.22149 1.35463 -1314 6 7.60527 6.19156 6.53697 16.5093 0.883216 -0.386471 -1315 4 6.7728 6.50088 6.91441 -4.77803 -9.70632 -1.71599 -1316 4 7.48617 5.31021 6.15237 -11.2115 3.19853 1.4886 -1317 6 14.6639 26.9856 30.1439 5.75321 15.8705 11.2484 -1318 4 14.5566 27.0259 31.1175 -3.12227 -7.05885 -13.9758 -1319 4 15.1715 27.7926 29.9326 -6.11328 -7.83436 0.701957 -1320 6 15.3386 3.73742 21.1629 -49.5233 -4.42818 1.41573 -1321 4 14.7513 4.15862 21.8308 22.5595 -2.74077 -5.2282 -1322 4 14.679 3.20837 20.6508 28.7222 9.19721 3.95726 -1323 6 18.6168 30.4391 6.46727 22.6827 -23.6706 30.2016 -1324 4 19.0357 29.7477 7.08277 -19.2097 26.0479 -21.7287 -1325 4 19.3376 31.0911 6.37388 -10.7119 -2.89972 -1.77141 -1326 6 40.7683 1.30949 12.8061 -7.58564 4.37034 -9.51004 -1327 4 39.8743 1.70123 12.8539 8.02325 -2.8267 0.614513 -1328 4 41.1302 1.62292 11.9594 1.79027 -4.37486 1.66609 -1329 6 17.747 20.7401 41.5828 -14.5708 23.9699 -22.25 -1330 4 16.8287 21.1121 41.5273 18.852 -12.8662 8.2158 -1331 4 18.269 21.3043 40.983 -0.296974 -7.34806 11.4382 -1332 6 20.4522 2.1467 12.3338 -13.8993 16.4183 -18.7538 -1333 4 19.8428 1.38545 12.4588 7.32118 14.6694 -7.56396 -1334 4 20.1591 2.61844 11.4836 4.96023 -26.6086 29.2353 -1335 6 9.8437 37.1731 18.0697 32.5344 -3.69518 -7.02483 -1336 4 9.9915 37.607 18.9153 -11.6933 2.16478 7.61773 -1337 4 10.7629 37.1686 17.7045 -22.2666 -4.61022 -1.39483 -1338 6 22.8273 7.39987 18.8956 -5.5011 7.28813 -36.492 -1339 4 23.2632 7.84344 18.1165 -7.98371 -8.25387 20.5209 -1340 4 21.8866 7.2843 18.6392 14.3432 0.686453 4.84686 -1341 6 12.8601 6.85899 39.0577 6.92589 -13.3495 -12.6124 -1342 4 12.2887 7.60854 39.1608 -14.8411 14.7282 0.271429 -1343 4 13.3423 6.79713 39.8797 5.00888 -0.905409 12.2129 -1344 6 10.1643 2.40912 23.2548 -13.4149 21.1074 -1.06732 -1345 4 10.2774 2.03439 22.3894 8.18098 -13.9841 -15.6202 -1346 4 9.49692 3.09648 23.049 6.99386 -4.39158 13.7206 -1347 6 12.5495 20.2147 19.5723 7.26787 8.21028 -18.3895 -1348 4 11.6895 19.7983 19.735 -1.5185 0.18686 -8.43892 -1349 4 12.6119 20.404 18.6017 -2.05058 -6.51038 26.2392 -1350 6 53.8702 6.35891 18.9198 29.7306 -6.18586 8.10346 -1351 4 53.0457 6.06715 19.2818 -21.258 -2.7468 0.110915 -1352 4 54.4788 6.08079 19.6257 -1.29631 10.1734 -11.3531 -1353 6 1.76233 4.00968 13.2412 15.2049 -20.178 -6.82767 -1354 4 1.1126 4.5015 13.7221 -14.7745 7.27862 5.55391 -1355 4 1.46634 3.0803 13.3195 6.22895 8.64986 -3.00031 -1356 6 2.68809 16.4658 4.58471 15.0105 -8.44828 17.4213 -1357 4 3.47968 16.3912 5.17607 -18.0483 5.65918 -16.5792 -1358 4 2.952 17.0668 3.88721 1.61121 4.43717 -9.18758 -1359 6 22.6412 7.38905 35.0491 -42.342 -19.7774 -51.2585 -1360 4 21.8701 7.10292 34.411 47.7649 22.3984 34.2121 -1361 4 22.4927 6.7758 35.7601 0.300803 -9.30322 17.5195 -1362 6 30.6449 27.8966 19.9 11.2186 24.5725 -17.4668 -1363 4 31.067 28.6028 19.3405 -15.311 -24.4133 12.7333 -1364 4 30.0502 27.364 19.3383 6.18265 4.0422 4.40167 -1365 6 18.3584 9.54031 6.21119 11.0026 -3.68808 23.2716 -1366 4 18.3645 9.12256 5.3612 -2.33489 -5.22153 -19.3682 -1367 4 19.1216 9.13552 6.66909 -8.40358 6.03455 -2.63927 -1368 6 21.0207 30.3946 30.8361 -20.2261 -14.3153 8.76877 -1369 4 21.7305 31.0371 30.8947 0.539155 4.23503 10.2216 -1370 4 20.6128 30.1908 31.727 18.9681 11.2591 -24.4987 -1371 6 28.3223 4.36971 15.0862 0.785553 22.566 1.53388 -1372 4 27.9162 3.53142 15.2341 -13.4814 -22.4749 6.99245 -1373 4 29.0547 4.16931 14.5133 14.7433 -0.183871 -4.75122 -1374 6 12.7699 0.652736 16.5284 -10.9622 36.0111 -3.70833 -1375 4 13.1417 1.43405 17.0195 -7.22472 -23.339 -11.6266 -1376 4 12.1312 1.03058 15.8629 17.1298 -5.78525 17.4901 -1377 6 27.5613 35.204 8.24204 -17.5468 -3.17574 2.50179 -1378 4 28.0037 35.3359 7.41158 3.58667 2.22765 -10.9792 -1379 4 26.8513 34.5538 8.04841 12.0719 12.2779 8.55847 -1380 6 24.0727 5.16129 41.0114 25.3265 34.0312 4.62534 -1381 4 24.5764 6.00631 41.0278 8.83913 -22.6202 16.662 -1382 4 23.4512 5.41721 40.3589 -27.9927 -11.5371 -21.4854 -1383 6 16.8577 24.9409 28.3044 -13.362 20.9446 -8.34262 -1384 4 15.8529 24.9248 28.4711 42.0709 9.51562 -15.4474 -1385 4 17.0929 25.6637 27.6385 -20.1406 -20.6283 22.1367 -1386 6 20.8367 12.7872 17.016 48.1357 -13.7972 -0.957512 -1387 4 20.9831 13.7012 17.3244 -4.24853 -6.44611 -2.53838 -1388 4 21.7731 12.3998 16.8344 -46.2893 13.5674 8.59046 -1389 6 35.7698 23.0286 30.9167 1.31549 -8.15919 10.0357 -1390 4 34.8007 23.0783 30.9694 4.38358 -0.634017 0.107585 -1391 4 36.0504 22.6611 31.7855 -2.79806 7.45108 -14.1947 -1392 6 36.3049 21.4 25.8723 16.8231 15.2703 -10.059 -1393 4 35.3849 21.2313 25.7163 -23.5769 -6.11261 -4.10927 -1394 4 36.6855 20.6326 26.2849 5.24534 -13.4215 6.45433 -1395 6 13.4896 6.74946 5.28081 -28.3592 57.2786 25.4238 -1396 4 13.8414 6.02988 4.86679 44.4058 -71.9847 -33.7479 -1397 4 12.7199 6.9047 4.75258 -19.8414 9.95147 -1.72496 -1398 6 20.8046 20.4221 13.7595 5.24729 11.8597 -23.4966 -1399 4 21.3314 20.3763 14.5586 1.04488 -1.4591 8.76088 -1400 4 19.8874 20.2651 13.9627 -8.54986 -4.70556 7.47732 -1401 6 20.3763 29.1306 1.39291 -22.654 9.61717 24.1604 -1402 4 20.4714 29.8874 2.01179 2.99602 -8.49852 -9.62387 -1403 4 19.4639 28.7985 1.61052 22.0838 3.18086 -13.1329 -1404 6 50.878 13.1268 37.2744 -6.92527 18.9089 19.2141 -1405 4 51.431 12.5903 37.8743 -5.40112 9.96959 -2.47836 -1406 4 50.5327 13.8902 37.8162 10.8793 -23.2499 -13.6212 -1407 6 33.933 34.1706 20.4988 -24.935 23.2996 -4.02345 -1408 4 33.9537 34.3969 19.5503 3.97405 -5.2202 10.173 -1409 4 33.1424 34.6907 20.8306 20.6842 -17.0796 -4.50693 -1410 6 26.2139 28.0427 27.5441 -18.3219 -6.87449 2.92541 -1411 4 26.6233 28.4264 28.3298 2.52406 0.509022 -5.28732 -1412 4 25.2474 28.0355 27.7473 15.6982 -2.70826 -9.65401 -1413 6 7.68199 21.3044 4.2899 -23.4352 7.97399 30.3744 -1414 4 8.39223 20.9571 3.80392 40.3202 -21.1106 -20.5498 -1415 4 7.23721 21.8696 3.67656 -12.7303 12.1883 -10.427 -1416 6 21.997 15.1678 5.91921 0.156106 10.1967 -8.47357 -1417 4 22.4631 15.3078 5.09012 1.49736 10.8302 -2.43488 -1418 4 21.9323 14.2285 5.99467 -4.63281 -19.7734 10.7123 -1419 6 21.7161 24.0028 3.81129 14.7157 -6.77156 -2.79544 -1420 4 22.6514 24.278 3.99089 -16.266 -7.57571 -5.80044 -1421 4 21.7278 23.1773 3.27349 4.3704 10.7286 8.25651 -1422 6 11.5654 23.7677 12.5675 4.34126 23.9889 5.0328 -1423 4 11.8179 24.711 12.3772 -5.51197 -27.812 -0.203907 -1424 4 11.194 23.7871 13.4529 -2.51135 -1.17837 2.27349 -1425 6 32.365 18.0609 29.8133 5.42876 1.07285 10.0727 -1426 4 33.2855 17.8495 29.9872 2.18588 2.92383 8.75228 -1427 4 32.2516 17.686 28.9464 -9.45666 -7.03173 -17.6671 -1428 6 9.26057 12.3901 30.3108 6.69251 -5.93803 -6.45383 -1429 4 8.9331 13.0089 30.9751 -1.99931 -0.452864 0.983921 -1430 4 10.127 12.0766 30.6488 -15.6011 7.03664 -5.16285 -1431 6 40.1575 25.9297 9.14135 -21.3024 -7.39617 3.31146 -1432 4 40.7828 25.2448 9.36979 6.64832 -8.60816 0.262948 -1433 4 40.6901 26.6937 8.96671 10.3695 18.4246 -3.8085 -1434 6 43.1786 32.337 37.3292 -33.551 -18.2832 -9.28851 -1435 4 42.7165 32.8749 36.6701 14.8891 8.67062 4.46068 -1436 4 42.4294 31.7351 37.5575 24.0939 3.67107 5.33039 -1437 6 44.0961 6.28371 31.2632 9.51948 -8.69332 -33.5784 -1438 4 43.4914 6.92213 31.6058 -15.4833 19.2503 12.9198 -1439 4 44.559 5.89005 31.9835 8.76633 -8.79917 23.1113 -1440 6 10.2083 18.8859 19.6919 15.5822 -2.80816 -8.35433 -1441 4 10.2079 18.3466 20.4907 -1.18434 0.124911 0.125127 -1442 4 9.35433 19.315 19.665 -12.7717 3.54701 3.24565 -1443 6 7.05259 15.5816 15.0277 -11.6868 16.7681 -20.4125 -1444 4 7.21112 15.523 14.0697 -0.749561 -1.2692 3.08306 -1445 4 7.39122 14.7797 15.3874 7.84577 -24.8334 9.86289 -1446 6 24.5366 3.48359 27.8583 16.7503 5.69766 5.18976 -1447 4 23.7024 3.43271 28.3539 -4.73503 -2.50774 -10.2909 -1448 4 24.4259 3.10654 26.9763 -12.6917 -5.22111 2.5626 -1449 6 54.3931 31.8073 9.72289 -3.19054 17.1237 19.0803 -1450 4 53.9641 31.62 8.89214 -6.37727 -2.00813 -13.4715 -1451 4 54.1243 32.7301 9.92854 3.65429 -15.124 -2.64791 -1452 6 6.79493 17.0949 36.2025 -8.81624 7.47492 14.5397 -1453 4 5.9165 16.6466 36.2092 18.1356 5.91394 -12.2869 -1454 4 7.21103 17.1598 35.3293 -13.3551 -7.88765 -1.67162 -1455 6 28.633 7.46221 20.4165 -21.0133 14.9556 -29.8407 -1456 4 27.7506 7.6389 20.7846 4.83271 -6.12746 3.71795 -1457 4 28.5316 7.77661 19.4783 9.56717 -7.40103 22.9991 -1458 6 17.0376 1.7027 8.35788 5.34968 28.5352 32.0038 -1459 4 17.0661 0.753124 8.28199 -2.4228 -14.8367 -20.8379 -1460 4 16.762 2.22772 7.59129 -1.56258 -15.3605 -8.12812 -1461 6 19.1384 19.3343 35.5751 19.5023 3.30605 7.15282 -1462 4 18.4451 18.7061 35.4179 -10.2251 -8.92118 -4.92207 -1463 4 19.8852 18.808 35.914 -3.54436 4.66685 -0.605832 -1464 6 7.31639 31.3666 13.5695 -43.9944 -20.214 -21.2721 -1465 4 6.78612 30.574 13.8569 21.4883 17.7075 -0.698983 -1466 4 6.68503 31.7843 12.9295 22.0056 -0.349161 9.64417 -1467 6 16.674 5.24419 12.8556 -11.0373 -33.5815 5.02698 -1468 4 17.465 5.75961 12.9546 20.2971 3.5869 6.63236 -1469 4 16.7677 4.34295 13.2785 1.53127 21.9447 -10.2143 -1470 6 43.8803 12.7494 34.5747 -22.4085 -20.9808 -0.0671255 -1471 4 43.9515 13.6536 34.2548 -4.30422 8.76569 -3.51904 -1472 4 42.9542 12.429 34.42 18.6754 8.57765 -0.433924 -1473 6 42.6607 36.4569 28.5239 -16.8168 -12.4187 2.20896 -1474 4 42.172 37.2929 28.6321 13.9601 -3.78206 -4.91178 -1475 4 43.5913 36.5775 28.2923 4.62592 13.2896 -0.105187 -1476 6 35.3772 15.0586 6.04009 27.912 48.9275 -7.18458 -1477 4 35.887 15.8982 5.7897 -19.1126 -32.2788 12.1212 -1478 4 34.8045 14.9281 5.27735 -5.52923 -7.04807 -1.55591 -1479 6 19.4078 5.85855 6.1829 -40.2001 -18.9085 -3.31614 -1480 4 18.5441 5.99364 6.63156 8.43156 -9.10613 -8.3884 -1481 4 19.928 6.53616 6.54489 31.8426 31.4232 15.0663 -1482 6 29.261 38.1682 6.98131 -37.2303 32.1811 -6.57247 -1483 4 28.4837 38.0966 7.57517 15.5489 -1.40449 -6.41795 -1484 4 29.8842 37.5088 7.21603 19.671 -25.1607 10.5683 -1485 6 19.357 26.1782 8.47801 4.74765 -18.9961 17.9486 -1486 4 19.3733 25.7814 9.38274 -2.97831 10.6699 -17.265 -1487 4 20.1618 25.7953 8.09114 -4.76457 3.34604 0.730176 -1488 6 4.92328 16.6713 6.1398 7.47336 5.27851 2.26954 -1489 4 5.50113 17.3858 5.8203 -2.76896 -2.40075 1.51866 -1490 4 5.42288 15.8417 6.02573 -4.96937 12.5626 -0.560722 -1491 6 6.06184 16.6875 28.0703 25.9558 6.64688 1.10321 -1492 4 5.15824 16.4097 27.9597 -16.212 -5.66481 -14.185 -1493 4 6.48748 16.8231 27.1848 -21.9791 -6.00697 19.2504 -1494 6 21.7362 29.3702 22.1089 -17.2737 20.913 34.8846 -1495 4 21.4452 30.3289 22.1112 6.19611 -27.0689 0.469942 -1496 4 21.3293 28.9728 22.9428 14.5469 12.9694 -26.9427 -1497 6 24.4985 0.540505 12.8515 12.2489 -9.36427 2.95715 -1498 4 24.0437 0.939092 12.114 -3.50986 5.42614 -10.4761 -1499 4 24.1106 0.99496 13.5957 -0.561841 3.41965 12.163 -1500 6 18.4019 28.2584 40.3145 -11.401 19.5033 -15.6681 -1501 4 18.3886 27.6361 41.0165 -1.05122 -20.6036 22.2694 -1502 4 19.1831 28.024 39.826 8.23901 2.08545 -8.43276 -1503 6 10.3826 17.4565 21.9113 1.92941 -13.2413 3.45357 -1504 4 9.8824 16.6205 21.8349 3.82121 7.52813 2.02092 -1505 4 9.93899 17.9725 22.5913 -5.82795 2.16988 4.16556 -1506 6 13.5489 13.3588 39.6353 11.9209 29.8927 39.0415 -1507 4 13.8427 14.2544 39.3649 -8.64321 -16.3346 -3.85104 -1508 4 13.5548 13.4385 40.6332 -1.97454 -11.1079 -31.9482 -1509 6 19.5449 26.0093 24.7389 -52.2633 13.2593 -7.73686 -1510 4 19.57 25.3975 24.0097 10.2262 -10.7296 -10.4349 -1511 4 20.3304 26.0184 25.2393 35.6126 -10.3894 17.1361 -1512 6 8.93096 25.8929 20.0882 -7.71251 -64.4566 3.30388 -1513 4 8.30787 26.3938 20.5887 -11.4685 32.8171 11.63 -1514 4 9.62246 26.3511 19.648 20.7791 34.2926 -13.3665 -1515 6 13.4555 41.2072 30.5108 -10.8988 -15.928 5.69795 -1516 4 14.2767 41.1294 31.0436 -12.4449 -5.39064 -3.38157 -1517 4 12.7718 40.5451 30.8276 25.6688 18.9533 -5.69319 -1518 6 21.165 21.6707 11.1126 6.53241 11.8742 3.94385 -1519 4 20.8889 20.8699 10.6872 -6.5221 -17.8932 -11.6656 -1520 4 21.171 21.4318 12.0451 -0.673303 -0.892159 6.0991 -1521 6 43.5659 10.3222 15.565 -2.18625 -17.2881 -4.53442 -1522 4 43.269 9.50121 15.139 10.696 3.36153 7.59808 -1523 4 42.8911 10.937 15.2983 -10.0921 17.3133 -0.93945 -1524 6 23.5255 5.06673 12.3063 -8.27451 55.1521 -7.02327 -1525 4 23.4703 4.15364 12.096 -5.93718 -33.8878 -14.7403 -1526 4 23.077 5.57318 11.5535 15.1023 -26.9196 22.8331 -1527 6 9.29314 15.4001 4.25145 -3.86255 -4.02248 -25.5662 -1528 4 8.9509 16.1187 4.78154 1.1615 8.22379 13.6068 -1529 4 9.97933 14.9549 4.74249 8.84801 0.0887981 11.7331 -1530 6 26.7067 10.8779 17.5788 3.55047 -19.7627 -22.9275 -1531 4 26.5537 10.995 18.4988 -3.13636 8.79354 30.8805 -1532 4 26.79 11.729 17.1566 -1.16375 6.51516 1.16674 -1533 6 26.0497 23.6027 33.6801 19.5894 25.2732 20.1931 -1534 4 25.4452 23.9936 33.0304 1.52608 5.68176 -1.06817 -1535 4 26.6384 24.3139 34.1277 -30.0139 -24.8801 -23.6693 -1536 6 7.5709 10.5028 28.9083 -0.962228 -19.583 -21.6711 -1537 4 6.74329 10.4799 29.4005 3.80738 8.46019 8.36633 -1538 4 8.19878 11.0832 29.3397 0.629116 8.24646 12.7121 -1539 6 16.498 16.9072 24.6485 7.82025 23.6222 16.3151 -1540 4 16.0345 17.7596 24.5588 5.31695 -3.73313 -0.390286 -1541 4 16.1792 16.4208 23.9083 -7.11448 -16.9587 -21.9433 -1542 6 12.549 12.7866 0.448591 8.35618 6.39845 34.9671 -1543 4 12.9768 12.9146 1.38779 -15.5602 -17.6496 -50.0052 -1544 4 12.7689 11.9205 0.0349689 0.659473 7.36742 13.3893 -1545 6 6.80731 2.45617 9.05869 -7.23501 -7.03372 -0.578084 -1546 4 7.10343 3.02287 9.78944 7.77528 -6.31722 -2.26682 -1547 4 7.3272 1.63733 8.99034 2.01029 5.74015 6.94656 -1548 6 28.8877 11.8706 12.0154 41.6386 34.6329 -2.99516 -1549 4 28.2108 12.4771 11.6895 -6.34049 1.49886 1.56166 -1550 4 29.7533 12.3393 11.8008 -29.7579 -18.4108 8.17464 -1551 6 44.6745 32.5962 29.7139 -34.2161 4.66467 6.73964 -1552 4 43.7628 32.9784 29.4642 35.9402 -16.1761 10.2258 -1553 4 44.5125 31.9002 30.3967 -1.3182 18.2082 -15.8911 -1554 6 28.5995 15.1068 32.2872 13.2766 -51.3111 -20.1848 -1555 4 29.0279 15.8582 31.8991 2.31019 19.0875 -3.40369 -1556 4 29.0943 14.3419 31.8537 -21.7517 23.8731 20.1718 -1557 6 1.14062 22.1898 33.6289 -39.3586 14.574 19.5436 -1558 4 0.65227 22.798 33.0535 3.91391 -2.7929 6.08546 -1559 4 1.82717 21.8879 33.088 34.4042 -16.5957 -27.8984 -1560 6 17.4513 16.8201 9.93098 -1.82085 -23.3459 26.2514 -1561 4 17.8906 17.1746 9.18159 7.86355 15.3521 -22.135 -1562 4 18.0267 16.0779 10.2085 -7.73246 7.19916 -1.96586 -1563 6 18.7435 29.8048 14.4095 21.7061 -3.72347 40.0221 -1564 4 19.5652 29.5706 14.9087 -19.4331 3.67999 -8.42588 -1565 4 18.9661 29.6909 13.4944 1.97037 -1.23698 -19.2163 -1566 6 39.4071 6.51101 13.0179 12.0574 6.81682 -11.0022 -1567 4 39.7785 7.30288 12.5709 -10.193 -11.7897 7.6563 -1568 4 39.9532 5.78104 12.6849 -4.03584 4.98089 5.48617 -1569 6 54.0977 38.2821 14.3159 8.76467 -13.509 23.2458 -1570 4 53.5116 38.6447 15.0061 0.0542658 1.01747 -18.4972 -1571 4 53.8554 38.6311 13.4594 -12.9742 11.219 -5.93773 -1572 6 7.52036 32.013 20.9427 34.362 14.2167 21.5407 -1573 4 7.05735 31.9924 20.1252 -18.8869 -6.37038 -21.2822 -1574 4 7.04171 31.4816 21.5607 -16.1882 -11.3569 11.099 -1575 6 26.965 15.5039 13.8257 -10.8147 -22.3452 14.7237 -1576 4 27.2177 14.7358 14.3683 8.65177 6.42067 -5.59001 -1577 4 26.0429 15.6169 14.0906 -6.80859 9.66341 -6.51148 -1578 6 18.3782 16.4473 32.1249 -4.95226 -1.86998 -9.87987 -1579 4 18.1426 16.6374 31.1969 4.73263 -0.719504 8.39792 -1580 4 19.0836 17.0573 32.3614 6.73072 6.57595 -2.73442 -1581 6 52.4873 31.678 23.2415 -44.1119 -6.58328 47.4356 -1582 4 52.4708 32.2686 24.0415 7.23299 -8.75358 -21.8316 -1583 4 53.1739 31.883 22.645 31.3465 14.6123 -23.9869 -1584 6 2.16824 9.71317 28.2162 5.46837 -18.1801 7.45826 -1585 4 2.48183 10.5213 27.7929 -7.61484 8.72751 3.65687 -1586 4 1.37959 9.87032 28.768 3.44281 10.2362 -4.06622 -1587 6 32.9194 0.0905733 22.5781 10.5432 -20.5017 -7.42813 -1588 4 33.2395 41.1185 22.3208 -17.3926 6.61176 1.08087 -1589 4 33.7441 0.505918 22.8191 5.29332 16.1982 3.6992 -1590 6 20.7309 41.5697 38.6372 28.3147 -14.9122 -44.687 -1591 4 20.0328 41.0591 39.0281 -13.7779 -1.58578 11.2509 -1592 4 21.0348 40.9602 37.8857 -7.98591 29.4899 32.1121 -1593 6 43.3035 24.332 12.1458 11.7575 -1.61212 -4.71191 -1594 4 43.2118 25.2792 12.3722 8.64503 -11.1136 -9.01316 -1595 4 44.1249 24.1975 11.6011 -17.6772 13.9566 14.4164 -1596 6 22.028 36.2965 11.8178 -12.5217 11.0116 -6.64335 -1597 4 21.6755 36.9888 11.229 7.35556 -7.61462 10.605 -1598 4 22.8593 36.0261 11.4203 4.02803 -2.23458 -0.408194 -1599 6 50.7458 20.5312 30.3336 -27.3371 19.0798 0.575242 -1600 4 50.2829 20.0188 31.024 4.3389 0.549123 -5.17754 -1601 4 50.1148 21.2814 30.1453 20.3707 -20.1638 4.65154 -1602 6 20.8352 3.85006 18.1924 -4.58005 6.82859 16.651 -1603 4 21.6331 4.17131 17.7775 4.55578 1.29171 -4.07778 -1604 4 20.7516 4.34878 19.0287 -0.852135 -6.30171 -7.97465 -1605 6 4.00732 20.6422 6.98905 -51.5603 -31.2986 19.6291 -1606 4 3.1116 20.4695 6.56725 35.2765 12.481 -1.34365 -1607 4 3.83148 20.2497 7.8921 17.5771 16.9916 -21.2359 -1608 6 11.9503 15.4361 41.4392 2.8915 -19.3712 8.63656 -1609 4 11.9967 14.4718 41.7234 3.98465 29.7679 -14.4511 -1610 4 12.4631 15.5787 40.6176 -3.08486 -9.43894 7.49139 -1611 6 3.00006 18.5443 38.9307 7.29951 -23.84 25.6029 -1612 4 3.57591 17.7463 38.8471 -9.50595 12.5214 2.28144 -1613 4 2.93408 18.9335 38.0756 -3.85177 13.2219 -26.1975 -1614 6 8.60604 38.8696 11.3027 41.4164 30.2615 0.48057 -1615 4 9.41419 39.0226 10.7506 -16.8144 -5.25469 8.62565 -1616 4 8.21901 38.0768 10.9944 -17.9318 -38.1368 -15.4555 -1617 6 12.9777 33.9736 38.4849 13.2116 9.7409 3.49313 -1618 4 12.6169 33.1824 38.0476 12.8065 1.18326 0.516457 -1619 4 13.9558 34.0654 38.367 -20.6967 -9.66923 -0.235313 -1620 6 4.68265 11.9882 6.05233 -5.36104 -17.6375 -21.4001 -1621 4 3.82121 11.6194 5.80881 -7.3972 4.97776 10.103 -1622 4 5.22981 11.6659 5.30604 -0.806592 6.4598 12.5779 -1623 6 10.8388 15.9226 25.2234 -25.8257 0.885817 -3.68505 -1624 4 11.7194 16.2357 25.361 23.5714 9.8582 3.12124 -1625 4 10.3656 16.637 24.773 5.49819 -5.38784 0.449897 -1626 6 20.7519 3.25216 6.54608 14.2232 16.6176 4.63006 -1627 4 20.286 2.47445 6.25961 -10.3965 -11.4853 -2.16446 -1628 4 20.1859 4.03183 6.47283 -6.25253 -2.40724 -3.99784 -1629 6 47.6296 39.155 31.2075 -6.94169 16.2372 -29.2685 -1630 4 46.6717 39.1522 30.9686 19.778 5.05469 4.61154 -1631 4 48.0746 39.7923 30.5789 -18.3255 -25.0069 20.1215 -1632 6 8.32942 27.7692 27.6861 -22.9675 10.5768 13.2964 -1633 4 7.92083 27.0814 28.2574 8.55111 11.2092 -8.24047 -1634 4 9.05389 27.3382 27.2479 10.5137 -11.4359 -5.41666 -1635 6 33.26 40.3166 33.4176 17.9089 -0.14465 -4.13778 -1636 4 32.5337 40.9457 33.2593 10.2249 -4.59604 -5.86803 -1637 4 34.0027 40.4737 32.781 -17.2015 3.54767 8.86095 -1638 6 24.5063 34.6298 27.2698 0.491312 8.45089 -9.78892 -1639 4 24.8706 35.531 27.0561 -9.74802 -22.5685 0.190878 -1640 4 24.1 34.2837 26.4337 10.8101 11.1551 19.1745 -1641 6 13.3248 36.7606 35.7302 31.7841 1.54421 8.12469 -1642 4 14.2215 36.6075 36.119 -13.0291 10.9369 -8.07597 -1643 4 12.8242 36.0333 36.0767 -19.6956 -11.898 1.78685 -1644 6 34.0654 20.1519 33.2169 18.328 45.6356 -7.38724 -1645 4 34.7846 20.5927 32.7056 -13.2567 -20.8909 7.62801 -1646 4 33.6055 20.9496 33.5712 -4.62613 -21.3045 2.82084 -1647 6 22.8301 33.56 31.6141 4.86266 11.3389 -12.2002 -1648 4 23.5774 34.1707 31.5466 -2.83601 4.36281 -5.03091 -1649 4 23.1188 32.9172 32.2538 0.234413 -13.6868 11.6365 -1650 6 23.7437 2.42751 19.8437 5.37542 22.288 12.015 -1651 4 24.549 1.92657 19.7151 11.8542 -9.34304 -3.08207 -1652 4 23.0522 1.96699 19.3939 -17.1839 -15.7883 -12.7178 -1653 6 10.5922 1.64055 20.5239 -11.6119 -4.18685 -4.47424 -1654 4 10.0475 0.976152 20.0603 6.63037 0.339841 6.84259 -1655 4 10.5 2.45781 20.009 1.22375 1.55874 1.33627 -1656 6 6.49834 24.8637 7.80908 13.1619 -16.462 -27.2261 -1657 4 7.39752 24.8711 7.42138 -7.39511 8.18905 12.026 -1658 4 6.07255 24.1767 7.26903 -7.5733 6.7583 6.8074 -1659 6 54.7892 32.5297 25.4757 -1.36407 18.5665 -18.8778 -1660 4 54.0312 33.1434 25.3693 10.0694 -13.7478 6.1371 -1661 4 0.333918 32.6202 24.6425 -12.8409 -6.42816 22.883 -1662 6 6.2467 20.1884 28.9797 -14.5872 3.94595 -2.55046 -1663 4 5.42154 20.1642 28.4577 8.07739 1.90281 8.6477 -1664 4 6.84484 19.6236 28.4838 10.3646 -4.74821 0.341067 -1665 6 50.0565 21.6117 11.3373 -2.04109 28.5423 -29.4123 -1666 4 50.95 21.7264 10.9878 2.40449 3.31798 -5.14809 -1667 4 50.1463 20.9073 11.9368 0.900865 -33.3483 27.1981 -1668 6 43.4794 33.5181 19.6392 10.2306 -3.22473 -8.26676 -1669 4 43.7308 33.5714 20.5426 20.9097 -0.172793 18.6354 -1670 4 42.5556 33.6283 19.7345 -31.1875 3.87355 -8.92325 -1671 6 30.8203 7.18413 41.0653 -47.5647 29.7584 13.5959 -1672 4 29.9879 7.63165 40.681 33.629 -21.8567 10.9994 -1673 4 30.7637 7.50249 0.10761 7.36747 -14.0232 -31.1296 -1674 6 12.1328 25.8622 11.0863 -33.3162 -17.1307 -4.35232 -1675 4 11.2035 26.0164 10.7385 31.652 5.74526 10.6132 -1676 4 12.7063 26.6022 10.9281 7.22016 21.1466 -6.88425 -1677 6 47.8272 5.81934 17.7377 34.4122 -10.5063 -19.6374 -1678 4 48.0885 5.28838 16.9377 -7.84164 17.03 17.5567 -1679 4 48.6906 6.1712 18.0872 -20.5621 -5.0871 -4.09565 -1680 6 35.1646 12.9005 16.5891 -8.94037 2.15609 -8.82704 -1681 4 35.428 13.0005 17.5199 -6.39768 8.78744 -5.13392 -1682 4 34.5308 13.6301 16.3523 17.2323 -15.7422 12.9621 -1683 6 10.4611 10.6156 33.9687 -31.8989 -9.58391 14.7288 -1684 4 10.7981 11.3375 34.5166 5.24051 -2.75865 -7.26377 -1685 4 9.62118 10.4004 34.4306 17.5569 -1.50819 -12.473 -1686 6 9.86916 7.4616 9.67483 -1.17411 0.415312 -19.5192 -1687 4 9.17172 8.12646 9.7346 0.921409 2.8109 10.1471 -1688 4 9.97058 7.3459 8.70248 1.1017 -0.154201 19.4763 -1689 6 11.1489 9.5612 29.1408 -3.50418 -13.4139 2.93109 -1690 4 10.6848 9.26325 29.9428 4.68224 5.10434 -5.79998 -1691 4 11.3989 8.73954 28.6776 0.998479 5.88331 1.3781 -1692 6 46.4028 12.7539 37.8993 8.34964 0.221 -8.93676 -1693 4 46.6625 12.9969 36.9769 -3.46511 -1.57209 17.4302 -1694 4 46.8246 13.3669 38.5286 -1.63466 -3.53539 -5.22058 -1695 6 4.76485 19.028 16.0085 -13.5875 12.8334 -9.71245 -1696 4 4.2246 19.0797 16.8211 14.4547 -7.44532 -2.23877 -1697 4 5.5965 18.5831 16.2078 1.83868 -2.3176 10.3072 -1698 6 50.2593 39.8135 19.3633 -11.209 7.32279 -16.1387 -1699 4 50.2357 39.0929 20.0186 -9.83071 -0.813057 -10.1916 -1700 4 49.5811 39.7404 18.6324 20.3589 -6.83946 23.6454 -1701 6 3.57863 23.2976 26.309 -19.8478 3.89203 -2.42552 -1702 4 2.95325 23.1663 25.5593 11.1236 -1.69658 12.5574 -1703 4 3.09228 23.9147 26.9028 8.7219 -10.8877 -9.85517 -1704 6 43.325 18.2347 20.509 -6.81505 -1.42332 -3.46621 -1705 4 42.8171 19.0284 20.7204 1.20306 1.51529 1.23812 -1706 4 43.8577 18.0426 21.2915 2.12676 -2.58083 4.4502 -1707 6 14.5031 41.5275 19.7277 -3.40329 -5.13047 -40.8094 -1708 4 13.9246 41.7804 20.437 0.184992 5.83632 25.1113 -1709 4 15.42 41.4218 19.9774 10.3149 -1.62678 14.571 -1710 6 29.2836 29.8681 26.9083 14.7251 3.00272 -32.0725 -1711 4 29.2754 29.741 25.8744 6.18055 14.2787 56.2455 -1712 4 30.1283 30.2623 27.2985 -22.384 -15.5718 -22.4063 -1713 6 6.3217 26.153 11.5726 -10.9318 2.11689 -6.65038 -1714 4 6.21736 25.7454 12.4421 7.16784 6.77942 9.71283 -1715 4 6.96084 26.8819 11.5675 -0.124344 -5.20772 8.78036 -1716 6 27.6636 9.22988 15.2432 27.2347 15.0341 -6.49447 -1717 4 28.4103 9.83484 14.9873 -20.1055 -14.3916 8.85848 -1718 4 27.7674 8.48088 14.6445 -1.45999 -3.40178 1.02673 -1719 6 29.7804 38.0662 17.0819 -1.94795 -3.59677 -9.66723 -1720 4 29.6031 37.2203 16.6025 -2.55573 18.1678 4.54076 -1721 4 29.1155 38.7497 16.8561 3.55432 -16.3657 1.57327 -1722 6 52.2257 28.7184 4.26028 43.5541 11.735 -13.9492 -1723 4 53.1498 28.7813 3.86382 -28.9168 1.3453 15.0129 -1724 4 51.9642 27.8111 4.13511 -4.98861 -18.1961 -3.0857 -1725 6 17.1716 16.6708 6.09349 0.800403 22.8617 11.3476 -1726 4 16.9906 17.4665 6.64994 5.32834 -8.85643 -15.9231 -1727 4 16.9912 15.9587 6.69883 -0.0606397 -19.1034 5.18453 -1728 6 36.6551 7.54529 33.4256 0.520164 -21.8515 26.6937 -1729 4 35.9994 7.02185 33.9501 8.71508 10.7979 -12.9224 -1730 4 36.139 7.85703 32.6949 -12.9525 8.58568 -17.7829 -1731 6 26.1712 3.13186 9.59195 18.1066 21.2961 -28.5304 -1732 4 26.5502 3.5196 10.357 16.0028 12.4994 23.003 -1733 4 25.6506 2.45477 9.93435 -32.3265 -38.1289 14.2303 -1734 6 1.19956 17.1196 33.1708 -2.2935 18.3305 -9.07621 -1735 4 1.01553 17.8006 32.4822 1.56489 -10.8534 12.1427 -1736 4 0.844206 17.4429 34.0214 2.04572 -1.59411 -6.06332 -1737 6 29.1739 10.178 5.37516 -2.40587 -18.3881 11.7134 -1738 4 28.5386 10.354 6.08377 0.376669 4.93981 -3.98875 -1739 4 29.4881 9.26834 5.54278 -5.29161 7.67482 -7.40705 -1740 6 9.22817 21.1342 0.188585 30.2393 3.90367 9.01386 -1741 4 10.0008 20.6689 41.6954 -19.6386 2.89796 1.05729 -1742 4 8.40981 20.8027 41.7407 -2.68979 -7.66638 -7.21336 -1743 6 7.42006 26.8879 34.8536 3.14545 16.5486 30.4349 -1744 4 7.04622 27.0927 35.7464 10.1233 -6.04195 -26.4158 -1745 4 6.87255 26.19 34.5186 -13.4343 -18.5802 -10.0193 -1746 6 18.6153 10.1647 3.02259 -21.2705 37.3854 6.86975 -1747 4 17.9982 9.42011 2.89287 2.11135 15.8633 3.52195 -1748 4 18.115 11.0437 3.25865 19.508 -44.5053 -11.6159 -1749 6 13.1266 21.2208 25.207 -7.78894 4.80204 -7.88194 -1750 4 12.927 21.6586 24.3646 3.95449 -7.72121 4.87382 -1751 4 12.8054 20.3208 25.1571 -2.69895 -8.80511 -3.48609 -1752 6 4.90585 24.4116 40.531 -24.4864 -14.2944 -35.1794 -1753 4 5.64285 24.6041 41.0938 21.6142 3.21823 7.1591 -1754 4 5.22115 23.997 39.6806 -3.1008 12.4445 27.1665 -1755 6 54.7234 6.29054 9.93868 16.9838 3.76988 -11.4262 -1756 4 54.1595 6.0167 10.6465 -16.0707 -8.53288 16.3243 -1757 4 -0.00708757 7.17696 10.1972 2.88265 8.42125 0.296955 -1758 6 51.7481 16.6603 19.3703 -0.380283 5.87397 -29.4424 -1759 4 51.6376 16.2748 18.4816 -6.94363 -1.60509 11.109 -1760 4 52.3909 17.3585 19.2003 6.35466 6.30558 5.78841 -1761 6 38.6244 2.9738 13.1093 11.8256 2.30897 44.7329 -1762 4 38.5518 3.44318 13.9917 -0.399232 -9.9856 -23.4333 -1763 4 38.2423 3.54447 12.4592 -11.1085 17.5319 -17.0773 -1764 6 19.4422 35.7095 9.59568 3.40577 -0.828385 -4.73593 -1765 4 18.7414 36.105 9.07989 -9.16576 -3.00828 -7.06541 -1766 4 19.0009 35.4265 10.4088 3.97598 4.46758 -4.25365 -1767 6 46.943 37.6271 25.6985 10.3793 1.77648 -5.56802 -1768 4 47.12 37.9785 24.823 -9.34628 8.6078 -10.4475 -1769 4 47.7536 37.1497 25.8683 2.27046 -5.59472 9.98269 -1770 6 20.0359 17.269 14.7493 3.99527 -1.04076 21.685 -1771 4 19.226 17.5112 15.2169 -1.54973 1.23777 -13.9596 -1772 4 20.6203 17.0021 15.471 1.89523 -0.789097 -10.2839 -1773 6 24.7462 29.2867 3.75843 -10.1451 -8.18783 10.4774 -1774 4 24.6712 28.3277 3.51733 13.2212 23.8029 -9.5704 -1775 4 25.3186 29.8222 3.19111 0.258423 -15.3949 -10.1904 -1776 6 3.43 8.91865 6.82525 30.9316 4.78471 42.1024 -1777 4 3.12906 8.84201 7.76799 3.51474 0.65101 -30.0512 -1778 4 4.4001 9.15772 6.93718 -35.8795 -6.21414 -10.2854 -1779 6 17.4867 30.5875 19.7089 25.363 -13.1809 -11.8275 -1780 4 18.4189 30.3609 19.3993 -33.7851 8.31766 10.936 -1781 4 16.9116 29.8624 19.4038 1.038 7.7974 -2.73085 -1782 6 13.2718 16.1862 39.0546 8.76191 -18.4723 6.03369 -1783 4 13.8233 16.8904 39.4031 3.30361 7.54485 1.72389 -1784 4 12.5422 16.5765 38.5789 -11.7633 13.4881 -8.40344 -1785 6 23.832 27.9756 11.5898 -7.03122 5.38421 -2.05105 -1786 4 23.0756 27.4469 11.9259 8.81977 12.3317 -3.01362 -1787 4 23.7182 28.9056 11.8688 -5.28793 -12.9553 -0.41204 -1788 6 14.4579 24.426 21.2343 -3.66896 12.863 -1.79834 -1789 4 13.9584 25.2806 21.2855 7.33453 -15.5065 2.73981 -1790 4 14.2661 23.9117 22.0367 -3.91682 9.90798 -0.991428 -1791 6 46.6073 15.1543 22.2965 -20.8333 -3.77381 -11.8272 -1792 4 45.9584 14.6421 21.811 -6.87655 -3.95362 10.1018 -1793 4 47.2458 15.2644 21.6001 24.1162 10.8017 0.759212 -1794 6 19.1409 29.7195 11.8497 24.0494 -34.2428 10.0272 -1795 4 18.8784 30.5975 11.5793 -19.1418 4.86007 -17.3781 -1796 4 18.6106 28.9994 11.4276 0.263541 23.8948 1.0376 -1797 6 36.9127 18.8084 27.6222 -22.9356 -21.6011 26.171 -1798 4 36.4352 18.471 26.8408 6.36827 4.7914 5.64024 -1799 4 36.536 18.2194 28.3533 14.6987 24.2872 -28.1415 -1800 6 35.8684 17.5378 25.4906 20.6945 -0.513689 -30.4481 -1801 4 36.5966 17.7728 24.866 -15.8574 8.27186 11.6809 -1802 4 35.9779 16.5759 25.48 -10.902 2.42848 10.2606 -1803 6 8.03691 41.9141 31.5248 13.0394 10.4535 -6.8036 -1804 4 8.57921 41.2412 31.9888 -13.1962 14.522 -11.1095 -1805 4 8.63283 0.684743 31.1326 -8.3799 -15.4286 7.32752 -1806 6 31.7059 34.8342 17.9371 1.99631 -25.0047 -8.79133 -1807 4 32.5911 34.4609 17.7211 -13.4776 12.334 6.09844 -1808 4 31.8527 35.7258 18.2497 13.1847 15.6537 3.27409 -1809 6 22.1093 41.055 5.1451 11.5479 29.9587 -53.8497 -1810 4 22.1004 40.5969 5.93279 -2.68624 -33.8843 55.363 -1811 4 22.7885 40.6204 4.60559 -4.38419 0.844423 3.37931 -1812 6 11.6153 5.16618 29.5584 -27.6475 13.1782 12.6346 -1813 4 12.1606 4.37097 29.6057 -8.91967 -2.9702 4.15115 -1814 4 10.7377 5.1092 30.0631 35.581 -10.2726 -16.0904 -1815 6 13.0239 9.45481 21.0754 -25.8377 -26.1508 -25.9824 -1816 4 13.6778 9.97234 21.4999 31.652 16.6928 15.5055 -1817 4 13.4195 8.72209 20.5617 -0.589626 12.3395 6.44381 -1818 6 12.4227 4.1736 0.163828 29.6522 45.8695 -12.8421 -1819 4 12.6651 3.77524 1.00427 0.341759 -1.42745 2.51987 -1820 4 13.0617 4.97102 0.020112 -31.9214 -41.0145 4.8633 -1821 6 45.168 14.6284 28.1023 4.783 -10.4532 13.0266 -1822 4 45.253 14.8969 27.1759 8.39119 -6.85383 -0.732919 -1823 4 45.9575 14.0916 28.3529 -13.3622 13.2892 -14.7888 -1824 6 52.571 19.2551 0.894665 -6.12931 -19.318 2.27414 -1825 4 52.6102 19.199 41.8388 0.592413 0.00811024 1.08479 -1826 4 52.8129 20.1442 1.11528 6.55776 18.4237 2.43046 -1827 6 0.161625 18.5694 30.5785 -3.0227 0.535636 4.36465 -1828 4 0.968981 18.7291 30.0798 6.18464 -7.16445 -2.53371 -1829 4 54.7907 19.4514 30.677 -10.8229 5.89199 6.00525 -1830 6 17.6528 28.1849 1.96402 -7.28907 9.7522 11.2687 -1831 4 16.9769 28.8628 1.74785 9.23997 -9.27082 -2.31394 -1832 4 17.6006 28.1534 2.93661 3.56557 1.38454 -8.44201 -1833 6 22.5099 30.1653 5.01109 -1.02808 20.8676 -0.473944 -1834 4 23.1753 30.1014 4.30975 -2.49536 -9.56192 4.09657 -1835 4 22.058 29.3206 5.04766 -1.45363 -6.71999 -4.50103 -1836 6 11.4023 8.80853 17.6459 -26.9993 9.53928 -4.75555 -1837 4 11.8645 8.1762 18.2108 15.3222 4.18532 1.52515 -1838 4 11.9865 9.48216 17.2519 4.47877 -12.4161 10.2871 -1839 6 32.2917 3.59674 26.8117 35.3382 32.7507 -4.14644 -1840 4 31.8458 3.34967 26.0065 -10.4154 -4.5889 -14.8452 -1841 4 32.8806 4.37505 26.5671 -21.1848 -26.3524 0.379863 -1842 6 26.835 37.1568 15.6529 -0.874066 14.8773 29.2405 -1843 4 26.7488 37.4766 16.567 0.376185 8.65421 -15.6923 -1844 4 26.6891 36.2303 15.7909 -0.851881 -23.4278 -14.9094 -1845 6 22.9473 3.40289 22.286 14.7574 -3.5158 -4.23343 -1846 4 23.2792 2.98888 21.4515 -4.53852 7.92848 16.4552 -1847 4 23.7307 3.68139 22.8048 -11.9145 -5.32443 -10.4265 -1848 6 14.6269 28.2214 5.19572 6.06687 6.51489 2.87291 -1849 4 14.1454 28.1555 4.36712 -3.39073 -3.27129 -8.45242 -1850 4 14.2747 28.9991 5.64824 0.61258 -1.12864 1.62503 -1851 6 20.2538 37.2031 16.5466 -28.2562 5.81675 18.2866 -1852 4 21.1004 37.4666 16.2032 21.0823 8.59207 -3.85991 -1853 4 20.0754 37.7549 17.3418 4.82626 -5.93036 -10.2325 -1854 6 17.9544 28.5616 23.889 16.4449 -8.57642 -4.83649 -1855 4 18.808 28.1928 23.5683 -20.3084 2.86715 8.85187 -1856 4 17.2559 27.9215 23.6535 6.51898 5.694 -2.26134 -1857 6 33.646 24.2349 25.2286 -4.54069 1.10679 -14.8717 -1858 4 33.6591 23.269 25.0602 3.54988 10.512 10.2941 -1859 4 34.0237 24.3938 26.1034 0.864522 -9.38336 -2.59148 -1860 6 9.98122 17.6138 2.21344 7.43797 -27.5786 -7.49496 -1861 4 10.832 17.5317 1.73219 -10.6429 3.93943 7.97636 -1862 4 9.86311 16.7639 2.69719 0.409905 15.8492 -4.6087 -1863 6 24.3357 36.801 8.92185 2.98992 -6.60779 12.1866 -1864 4 24.0742 37.6409 8.56425 -5.30422 15.3919 -5.44039 -1865 4 24.7315 37 9.77917 -2.43549 -6.6012 -3.30269 -1866 6 14.4004 4.29557 27.7519 47.583 -3.32523 5.14754 -1867 4 15.335 4.40276 27.3948 -30.4143 -4.44284 13.8265 -1868 4 13.81 4.42145 27.0177 -13.2435 3.17509 -11.8406 -1869 6 13.214 25.4576 35.3169 -22.1271 -24.6319 4.29258 -1870 4 13.1587 25.1592 36.2444 11.1778 9.47444 -6.90086 -1871 4 12.4637 24.9943 34.8985 11.1514 12.2923 -1.08233 -1872 6 43.7301 33.1781 24.4042 -1.93578 -20.5981 16.0744 -1873 4 44.3223 32.959 25.1725 -10.0543 8.3706 -19.7015 -1874 4 44.0713 33.9344 23.9169 6.22405 5.02536 3.22562 -1875 6 6.9686 30.4099 7.14637 29.0056 7.39031 21.9321 -1876 4 6.75777 29.9621 7.98042 -5.17066 0.417247 -5.37485 -1877 4 6.23168 30.2842 6.57126 -23.4728 -6.8193 -11.7975 -1878 6 44.4308 39.4237 21.7855 -4.33275 0.914597 7.54549 -1879 4 43.8654 38.932 21.1541 10.179 9.64354 2.62582 -1880 4 45.001 40.0603 21.3196 -6.51882 -12.4268 -7.79327 -1881 6 1.18424 16.4398 24.9903 -32.4903 25.5998 2.59769 -1882 4 0.976951 16.9992 24.2076 17.4753 -17.2203 8.72915 -1883 4 0.385168 16.6115 25.5394 23.4019 -14.126 -4.16352 -1884 6 8.17355 33.8284 10.6836 -2.7688 -6.92624 14.1509 -1885 4 8.34263 33.4451 9.83813 20.7133 -1.8248 -25.0865 -1886 4 7.32622 33.4212 10.8229 -22.0824 -0.650197 20.9959 -1887 6 45.3734 15.866 40.492 8.57481 -12.1553 -4.93844 -1888 4 44.519 15.6937 40.0698 -0.240559 4.546 7.41406 -1889 4 45.2892 16.6061 41.0987 -5.95018 0.957053 0.609678 -1890 6 38.79 4.28815 15.8976 0.37918 -2.10791 -10.8791 -1891 4 39.6838 3.98516 16.099 -1.14178 2.00828 6.51653 -1892 4 38.4576 4.71748 16.7012 5.69678 -4.45181 -3.36891 -1893 6 21.0946 9.20757 23.9781 -15.5567 7.8487 -28.256 -1894 4 20.9171 8.74785 23.1381 12.0597 -4.77706 12.6228 -1895 4 20.522 9.98378 23.8483 8.03519 -2.74416 16.612 -1896 6 6.47513 36.1489 20.0112 1.62078 -0.443995 1.26518 -1897 4 5.91587 35.3892 19.7749 1.1588 6.62155 -0.72477 -1898 4 7.29927 35.7814 20.3561 -3.99682 -1.77997 -1.59627 -1899 6 17.7466 23.4563 11.2529 28.5847 -29.2717 26.027 -1900 4 17.0283 23.9723 10.9251 -27.3158 17.875 -1.49359 -1901 4 17.6201 23.2782 12.2162 -8.22502 9.28058 -23.7318 -1902 6 2.23619 39.2644 23.5388 49.8561 -28.1857 -22.6679 -1903 4 2.97831 38.9599 24.1359 -27.9038 8.524 -11.8523 -1904 4 2.61824 39.0932 22.6246 -22.7997 11.7085 33.9524 -1905 6 21.7216 10.3211 3.08421 -18.2449 14.4951 30.0936 -1906 4 21.8041 10.0076 2.215 15.0715 -18.3252 -42.7176 -1907 4 20.7597 10.3501 3.18369 2.1836 1.89441 6.77029 -1908 6 13.3346 37.6456 26.8309 31.2085 -13.7023 -2.95714 -1909 4 12.8405 36.9633 27.2803 -9.16641 -7.21061 8.74396 -1910 4 14.167 37.1703 26.5501 -23.1686 18.0804 4.61389 -1911 6 45.6739 9.85296 8.82966 10.4005 6.57186 1.33947 -1912 4 45.3411 9.70411 7.93855 -5.0879 -2.60549 -0.62074 -1913 4 45.1871 9.30295 9.44221 -8.90854 -6.98805 -1.17873 -1914 6 39.813 32.3454 29.581 6.89703 -12.1014 5.95535 -1915 4 39.6485 31.4219 29.3549 -7.08038 -1.01192 -10.7476 -1916 4 40.3223 32.2375 30.3827 0.600223 8.34958 5.32896 -1917 6 39.1399 32.1558 8.97291 22.8595 -6.45003 -40.3239 -1918 4 39.6086 32.0592 8.09926 -10.5081 2.64219 35.3633 -1919 4 38.2198 32.2158 8.71089 -7.955 1.72328 8.07951 -1920 6 29.7568 11.3071 40.3305 36.1908 -28.2332 -10.1569 -1921 4 29.0987 10.6276 40.5022 -6.8613 -0.261357 1.73371 -1922 4 30.5966 10.7518 40.2867 -25.0211 23.0598 -1.19829 -1923 6 24.8367 19.8778 29.8512 -3.76004 22.8831 22.3698 -1924 4 24.8428 19.0032 30.2276 -1.20959 -17.1847 2.11456 -1925 4 24.5914 20.4528 30.618 6.24059 -13.3215 -18.0816 -1926 6 50.0702 29.4819 2.87168 7.70946 6.50978 -10.1722 -1927 4 50.8345 29.4231 3.46787 -5.92296 0.441099 -8.02421 -1928 4 50.4135 29.3271 1.96617 -11.3825 0.248157 19.2026 -1929 6 26.3309 13.2577 37.9673 -13.8105 -3.9786 -34.6653 -1930 4 27.2227 13.0528 37.6163 -4.21147 3.58808 27.148 -1931 4 26.2568 13.475 38.8976 18.37 3.27206 13.6317 -1932 6 24.3356 13.8068 16.1475 3.59325 -0.347239 -0.208698 -1933 4 24.7367 14.1162 16.9522 4.68271 -6.41054 14.6744 -1934 4 24.1923 14.631 15.6832 -6.43367 3.48529 -13.6665 -1935 6 21.9593 25.0956 8.01078 27.9223 3.76027 7.52529 -1936 4 22.6404 25.6041 7.51239 -14.7718 -5.75747 5.32796 -1937 4 22.4795 24.6555 8.71494 -11.0917 7.59151 -10.9937 -1938 6 50.1732 25.2931 29.034 -22.8769 -27.0861 -14.4889 -1939 4 50.9231 25.1249 28.4453 9.52927 7.92169 5.9345 -1940 4 50.3853 25.9631 29.6741 16.3661 14.9722 8.20298 -1941 6 23.1854 6.82331 7.6223 5.22953 23.7057 -4.54178 -1942 4 23.9785 7.3899 7.84298 -26.8007 -12.7469 -6.01791 -1943 4 22.4118 7.42329 7.468 18.2581 -13.076 4.30509 -1944 6 6.92213 5.8571 20.8332 2.72627 6.95854 -11.5419 -1945 4 7.54915 6.58218 20.6217 -11.8273 -13.0803 1.39721 -1946 4 6.56012 5.53917 19.9848 5.57208 -2.46181 7.62025 -1947 6 25.395 39.7583 23.949 6.36773 8.3837 -46.9746 -1948 4 25.6324 38.8356 24.0083 0.522678 -6.92882 12.1803 -1949 4 25.626 39.9451 22.9935 -8.38215 2.07882 31.2615 -1950 6 10.8464 30.695 2.12273 2.92699 -11.4721 29.0623 -1951 4 9.93667 30.8598 2.41274 2.41412 3.42254 -4.79395 -1952 4 11.0072 31.0743 1.26994 -5.60296 10.8359 -22.248 -1953 6 23.0784 40.5299 40.0517 -12.8303 7.3127 -19.6888 -1954 4 23.7801 40.7079 39.3995 -2.98216 -3.06267 5.67195 -1955 4 22.2752 40.9489 39.6621 13.0026 -6.04267 8.58422 -1956 6 29.2116 28.3822 37.564 -38.7174 33.0362 -17.1388 -1957 4 28.2182 28.3913 37.3962 39.4392 -4.09178 7.25715 -1958 4 29.4217 27.5495 37.9564 8.20519 -19.4736 9.10227 -1959 6 1.867 12.1738 18.0852 -6.50713 5.08339 -35.4355 -1960 4 2.57398 11.838 18.6163 6.10024 -5.16113 22.8519 -1961 4 1.13063 12.5086 18.5994 -2.48645 -2.83143 13.3981 -1962 6 35.8305 14.0949 8.56039 26.0881 18.3061 13.156 -1963 4 35.1714 13.4739 8.88749 -16.8661 -4.96187 -13.4504 -1964 4 35.7684 14.4109 7.636 -16.9096 -16.2229 2.78164 -1965 6 9.49198 39.8165 37.5846 25.5398 -19.6342 8.10058 -1966 4 10.4488 39.5668 37.3792 -35.3087 19.1509 -1.98674 -1967 4 9.11285 40.4907 37.0027 15.1686 -3.88151 -5.41116 -1968 6 3.54864 30.3444 19.2746 19.2588 -4.84534 25.5649 -1969 4 4.39288 30.8221 19.2218 -5.35887 2.33403 -8.35831 -1970 4 3.69938 29.8 20.0823 -8.98886 6.07327 -15.723 -1971 6 36.3172 32.3761 17.5568 -52.716 -14.5505 -10.7859 -1972 4 37.1181 32.7413 17.8285 45.3049 23.5946 19.1732 -1973 4 36.5447 31.7674 16.8589 0.0557097 -8.91784 -8.34906 -1974 6 22.0674 24.5243 41.4066 13.5104 10.4808 14.5301 -1975 4 21.9193 25.2614 0.114872 1.55544 -1.48024 -5.36737 -1976 4 21.3782 24.5469 40.7428 -11.5581 2.78113 -8.36201 -1977 6 45.7659 15.6016 11.6394 9.02046 4.78635 -7.96304 -1978 4 46.6299 16.0103 11.8091 -2.50167 -1.58301 0.968075 -1979 4 45.9087 14.6499 11.5698 3.7439 -8.72722 -0.994242 -1980 6 22.3679 20.3809 16.0361 -10.6504 -17.4294 -19.3744 -1981 4 21.763 20.3139 16.7773 -4.42579 5.53693 13.3566 -1982 4 23.0073 21.0579 16.2253 11.6801 17.1208 13.2616 -1983 6 25.8325 25.7487 18.9031 6.26908 13.5994 -10.9759 -1984 4 25.2398 26.4837 18.648 3.49723 -12.6326 6.8661 -1985 4 25.3435 25.2434 19.5576 -3.6765 -3.23145 -0.768961 -1986 6 35.3178 34.202 33.2905 -17.6504 -29.1706 1.13026 -1987 4 35.3983 35.1402 33.2641 1.24044 29.706 -1.15043 -1988 4 34.4344 34.0427 33.6774 7.05439 -0.467604 -1.03347 -1989 6 39.2901 17.1075 17.3833 -11.3112 -26.2042 -1.68945 -1990 4 39.9794 17.7123 17.5836 17.425 19.0869 4.79839 -1991 4 38.575 17.6263 16.9966 -1.50153 2.1098 -0.940241 -1992 6 0.398412 14.9432 21.7856 9.03058 1.70326 -1.90296 -1993 4 54.4474 14.9193 21.5731 -3.898 -0.019948 -1.7993 -1994 4 0.528431 14.174 22.3634 -0.170355 0.861544 -0.399335 -1995 6 15.987 23.2263 17.7743 4.36624 14.6934 -7.14303 -1996 4 15.4857 22.9799 16.9684 3.82047 1.22984 7.38673 -1997 4 16.1722 24.1939 17.7179 -4.44652 -15.4901 1.96988 -1998 6 5.24865 11.1141 17.5618 6.95422 37.8037 -9.42255 -1999 4 4.73778 10.3127 17.5906 4.69561 -15.2682 10.3552 -2000 4 6.07662 11.1201 18.0866 -14.6292 -19.4463 0.240297 -2001 6 9.34435 36.7122 13.2675 14.3848 -20.4853 -8.45434 -2002 4 9.62142 35.7704 13.1913 -3.31983 12.7393 -0.467066 -2003 4 9.65952 37.1602 12.4706 -4.49166 -2.86228 3.29419 -2004 6 25.4918 33.5767 0.585194 -13.2513 47.819 -13.0434 -2005 4 25.5067 34.5261 0.924259 2.87868 -31.0124 -5.96193 -2006 4 25.9276 33.0244 1.21144 10.5779 -12.847 23.4116 -2007 6 17.3034 24.3894 31.3332 -3.83374 11.0726 -5.16798 -2008 4 17.6693 25.1812 30.9068 -1.9735 -3.85303 -0.254684 -2009 4 16.6127 24.6926 31.9382 -2.66612 -1.73239 2.61398 -2010 6 50.552 32.7161 27.7939 3.69414 -2.86079 -12.6149 -2011 4 50.6897 33.0491 28.6758 -0.144502 8.45372 13.0825 -2012 4 49.6264 32.8868 27.6344 -12.0524 -1.73095 -4.05681 -2013 6 2.253 37.2274 16.11 8.45807 0.136394 4.49883 -2014 4 3.21927 37.2459 16.107 -3.10104 -5.97474 -11.5471 -2015 4 2.06307 37.5747 16.9848 -8.61924 1.9026 3.91491 -2016 6 25.7683 33.176 8.40354 -18.9203 -11.3347 4.07551 -2017 4 24.8717 33.1921 8.8134 13.9609 -2.48357 -8.81655 -2018 4 25.7602 32.4226 7.7918 -3.67744 3.53954 1.65329 -2019 6 24.768 7.83219 25.4219 17.632 21.1734 16.2998 -2020 4 25.4945 8.36147 25.0103 -20.1597 -14.0103 5.71998 -2021 4 24.2535 7.44908 24.728 -12.2137 -5.73332 -20.4071 -2022 6 44.006 27.3325 21.546 30.1554 -7.9652 -11.3918 -2023 4 43.2457 27.8583 21.7575 -19.7371 1.57643 -2.46296 -2024 4 43.7964 26.4976 21.0884 -11.5694 12.3441 5.98804 -2025 6 20.8391 32.0716 6.72617 12.9902 -8.35788 -26.5741 -2026 4 21.6065 31.456 6.61879 -16.2643 13.1482 10.0653 -2027 4 20.6646 32.3142 7.64123 9.40483 -3.67012 8.54308 -2028 6 0.615177 26.1024 3.99379 -2.52029 5.686 8.70358 -2029 4 0.872898 25.4419 3.3518 0.34785 -8.86692 -8.8337 -2030 4 1.24928 25.9906 4.70547 -1.00806 2.16518 1.82635 -2031 6 23.6932 0.22266 22.8575 19.6208 -9.09848 8.51526 -2032 4 23.2991 1.09802 22.9795 5.26519 -2.66393 -0.960482 -2033 4 24.6108 0.216177 23.2468 -26.6208 7.90328 -9.41734 -2034 6 35.6316 26.9489 6.47476 -11.9227 4.67096 -7.07616 -2035 4 36.2784 26.7656 7.18499 -0.847143 10.2035 -9.59556 -2036 4 35.6247 27.8854 6.12936 11.6979 -23.4314 22.5499 -2037 6 50.1669 7.09081 18.6924 -7.14542 -1.6973 -3.47771 -2038 4 50.8011 7.27946 17.9805 -1.08143 -0.293524 0.841141 -2039 4 49.7425 7.94753 18.8476 4.63932 0.367722 -3.05405 -2040 6 12.4741 14.8288 12.1922 -8.10271 -9.61402 10.4649 -2041 4 11.6958 14.4794 12.6802 13.1948 7.08912 -7.97814 -2042 4 12.1183 15.3251 11.4609 -4.91784 2.70917 -6.99785 -2043 6 52.4614 22.3688 36.3388 -11.0199 -17.3524 -23.0567 -2044 4 51.6251 21.9183 36.1306 -2.17212 11.6706 13.3338 -2045 4 52.9952 21.963 35.6316 8.38603 12.1418 11.4133 -2046 6 41.778 11.4842 39.1192 -2.94788 -8.5466 -71.3066 -2047 4 42.0712 11.6935 39.9642 18.9262 14.1801 48.2999 -2048 4 42.4688 11.7778 38.472 -13.5225 -5.5757 18.7019 -2049 6 13.7869 22.5139 39.1025 -32.0544 -7.10206 -10.9841 -2050 4 12.8164 22.2898 39.2995 40.1723 6.0649 -15.4789 -2051 4 14.0276 22.2847 38.1645 -11.932 2.241 24.8997 -2052 6 28.7471 19.519 21.8427 26.201 -31.4587 -3.42241 -2053 4 29.5077 18.8642 21.7553 -27.3151 19.4313 7.21597 -2054 4 28.709 19.939 20.977 -1.33904 3.86677 -3.41873 -2055 6 8.35104 21.6464 36.3873 -9.70021 11.1463 1.78198 -2056 4 8.59231 22.5715 36.3877 5.92817 6.74417 -5.91108 -2057 4 7.6521 21.6323 37.0621 1.10663 -7.27579 -5.05072 -2058 6 39.9466 23.9759 15.2079 21.5993 -7.98015 -41.1742 -2059 4 40.8727 23.6245 15.2724 -23.8836 11.1149 -0.884493 -2060 4 39.7538 23.9548 14.2182 -0.675121 3.14563 34.0025 -2061 6 8.14826 38.6974 22.5407 10.5164 -8.10765 28.5856 -2062 4 7.68497 39.3831 22.0542 -4.5186 11.15 0.90042 -2063 4 8.43687 39.0737 23.4204 -11.1896 -2.29822 -22.518 -2064 6 10.8609 20.1732 28.9608 12.8413 -0.923384 7.34695 -2065 4 10.0131 19.7426 29.0637 -5.9523 -4.47565 4.1188 -2066 4 10.8844 20.5008 28.0696 -0.703946 5.19258 -12.1525 -2067 6 36.9008 23.822 41.8156 -12.4363 21.7846 -10.0393 -2068 4 37.5711 23.2333 0.167128 40.9996 -19.7248 12.2972 -2069 4 36.1173 23.3131 41.9445 -23.6506 -5.40851 2.0223 -2070 6 23.7894 40.6868 33.3454 12.8596 -15.6087 -7.6142 -2071 4 23.0064 40.9655 33.8068 -12.9523 11.6172 4.83708 -2072 4 23.8763 39.7481 33.6232 3.5481 12.5289 -6.50269 -2073 6 4.67002 19.3025 35.4081 28.9654 -8.37802 15.8464 -2074 4 5.50304 19.0977 35.9037 -20.926 10.8248 -6.78781 -2075 4 4.54874 18.5079 34.879 -7.50763 -2.93955 -6.02594 -2076 6 9.44906 25.7726 10.897 4.32597 -4.58851 8.60165 -2077 4 9.18995 24.8319 10.8983 -5.5655 4.98255 -0.925486 -2078 4 8.69969 26.3126 10.6078 0.159443 -6.7376 0.514864 -2079 6 27.2776 22.4912 13.6121 -0.517147 -7.99313 -8.85992 -2080 4 27.155 21.7331 14.2088 0.0551372 2.14825 -2.63665 -2081 4 27.5226 22.1158 12.7439 -1.12325 6.52643 14.1544 -2082 6 41.0473 18.7721 23.2805 -1.65607 -7.19044 -7.91226 -2083 4 40.4257 18.2083 22.8124 7.09703 -3.21037 0.549063 -2084 4 40.4899 19.4448 23.6465 -2.2525 13.4867 10.2584 -2085 6 46.4847 28.3568 20.1596 21.4343 7.62243 20.4812 -2086 4 45.6558 28.0725 20.6313 23.6124 6.3397 2.68094 -2087 4 47.3103 28.4552 20.7557 -43.4876 -6.08109 -17.1535 -2088 6 14.856 15.3945 30.0569 12.1054 -1.48105 24.8406 -2089 4 14.6669 15.4041 29.1302 -8.67008 -4.83168 -20.7775 -2090 4 14.3859 14.629 30.4429 4.17574 5.50589 -6.96103 -2091 6 23.5299 24.7674 35.2089 8.01546 19.7663 24.3744 -2092 4 22.8065 25.3632 35.4756 2.8295 -9.26237 -7.23473 -2093 4 24.1647 24.8645 35.9517 -5.58112 -4.18239 -8.07128 -2094 6 19.8979 24.2128 28.4372 -8.55524 33.371 -10.5251 -2095 4 20.118 25.106 28.0235 -7.554 -30.7898 14.4583 -2096 4 18.9386 24.2465 28.5992 8.91169 -0.342387 -2.75065 -2097 6 45.9653 7.62821 20.2375 0.645938 -6.46631 40.9505 -2098 4 46.1455 7.81465 21.2011 -4.75538 -9.14986 -26.6761 -2099 4 46.2053 8.42523 19.7798 3.02803 13.7202 -10.1214 -2100 6 38.0274 12.476 8.2804 -12.7973 12.3245 -4.6187 -2101 4 37.3544 13.1993 8.5286 18.4233 -41.2645 -20.6098 -2102 4 37.689 11.8001 7.60922 -1.16355 31.2483 23.3325 -2103 6 46.9232 18.1908 8.45127 -20.6048 6.85227 14.7641 -2104 4 46.2435 17.4987 8.55233 4.56757 4.50302 -0.225601 -2105 4 47.4224 17.9381 7.68168 11.4282 -5.99968 -17.9171 -2106 6 10.854 13.9656 9.37577 10.6617 18.3473 -18.9154 -2107 4 10.3554 14.661 8.90618 -4.87744 -10.6328 11.7585 -2108 4 11.7492 14.0754 8.99486 -7.79483 -7.36366 10.4335 -2109 6 34.413 5.42618 14.0852 -12.6861 0.159125 26.6885 -2110 4 35.1199 5.9296 13.6715 10.4361 -4.78744 -13.6438 -2111 4 34.2786 4.53955 13.7091 11.464 2.02167 -7.62295 -2112 6 0.18261 0.234369 22.9555 2.77695 -16.1069 -0.480131 -2113 4 0.268342 41.6651 22.1144 -0.0234796 4.94264 7.55149 -2114 4 54.831 1.09037 22.7433 -8.12427 18.964 -5.90735 -2115 6 40.9343 30.5497 37.8912 -0.822728 -5.40818 -2.29365 -2116 4 40.0406 30.8803 38.1728 23.6728 -16.1598 5.2797 -2117 4 41.3254 29.8415 38.4693 -14.8835 20.0143 -6.13723 -2118 6 16.6534 17.3205 12.6874 14.7099 15.3782 -9.06546 -2119 4 16.1954 16.505 12.4572 -1.18797 -4.10455 -0.493236 -2120 4 17.006 17.6533 11.8352 -5.05849 -6.69802 12.8635 -2121 6 29.6898 5.4323 24.749 -0.0153423 -4.79708 -9.00604 -2122 4 30.3311 5.93507 24.2276 2.5605 1.293 3.45927 -2123 4 29.9547 5.54756 25.6733 0.859724 2.70473 -2.20341 -2124 6 49.8976 0.279 27.2063 11.3554 -10.6099 9.68168 -2125 4 49.8114 0.578981 26.2935 2.75523 0.634109 -3.06626 -2126 4 50.8097 41.8349 27.2847 -10.6363 5.42595 -5.44518 -2127 6 31.2372 31.739 15.2138 3.99594 22.7956 -4.27207 -2128 4 31.6256 30.8953 15.4507 4.79789 -4.71254 6.82751 -2129 4 31.9624 32.4004 15.1381 -14.4355 -14.737 3.33184 -2130 6 35.7805 24.1465 16.9504 11.9916 -3.59376 -8.04525 -2131 4 35.6914 24.9231 16.3572 2.28972 -11.6943 5.94213 -2132 4 36.6882 23.763 16.8157 -19.8391 7.30154 4.46135 -2133 6 24.2601 4.62781 36.7306 -2.73038 -12.1142 -21.0154 -2134 4 24.8177 5.17448 37.2794 5.25293 5.76293 7.44764 -2135 4 24.6802 4.67277 35.8537 -9.35577 -2.69704 9.81341 -2136 6 17.5719 12.8989 3.66466 27.7221 -13.8379 -12.2911 -2137 4 17.7111 13.5231 2.92461 -8.26776 -5.83385 13.2655 -2138 4 16.7968 13.1561 4.15408 -15.8703 8.33112 4.7305 -2139 6 4.16771 14.2922 18.2601 -1.91899 -29.1082 -10.1028 -2140 4 4.22837 13.3107 18.2109 4.90834 19.7408 -0.578384 -2141 4 3.27435 14.4381 18.5824 -9.9871 6.86755 4.44487 -2142 6 19.1699 36.8381 22.3902 -4.55286 10.0742 -5.97046 -2143 4 18.832 36.3461 23.1414 -4.92402 -9.67799 11.164 -2144 4 19.5712 36.1952 21.8056 6.33502 -12.5333 -3.55186 -2145 6 15.653 11.96 13.2084 19.351 18.6963 0.185202 -2146 4 15.6609 12.833 12.7547 -2.35489 -19.4305 9.56752 -2147 4 16.5767 11.8359 13.5469 -18.24 -1.16426 -6.81767 -2148 6 24.7461 21.9204 5.38797 -27.1503 3.38708 1.08719 -2149 4 25.0422 21.7466 6.29562 -9.42613 0.489783 0.293639 -2150 4 23.7615 21.7936 5.33342 31.5349 -1.60743 10.1723 -2151 6 52.731 18.5617 35.2291 -23.3227 -9.96089 -3.35821 -2152 4 52.3432 18.0885 34.4925 12.0283 -8.22578 -16.7439 -2153 4 51.9379 18.6142 35.7503 -4.18579 12.1235 24.3517 -2154 6 3.56339 27.2782 25.2861 -13.9068 -17.971 -11.9546 -2155 4 3.93933 27.1708 26.1554 6.48024 -2.07304 15.4908 -2156 4 3.97283 28.0403 24.8958 8.97188 17.1762 -5.24442 -2157 6 34.4703 32.9949 30.674 6.71734 26.132 41.1649 -2158 4 33.5303 32.9277 30.8218 -10.267 -13.4259 -20.1884 -2159 4 34.6757 33.5653 31.4552 13.6938 -14.1125 -21.2315 -2160 6 35.2703 23.7477 9.841 1.59588 4.98779 0.126485 -2161 4 34.557 23.9691 9.22977 0.987563 3.83206 0.754652 -2162 4 35.6213 22.923 9.5082 6.82753 -10.3388 -1.5208 -2163 6 42.4139 15.7114 8.97964 24.1102 0.334397 4.42901 -2164 4 41.6569 15.4185 8.4899 -23.1764 -3.9339 -8.15459 -2165 4 42.1019 15.9745 9.85446 -9.30455 -0.897043 1.06511 -2166 6 7.76859 28.8573 32.9442 -15.9037 16.0354 -10.4898 -2167 4 7.97908 28.1549 33.5519 6.36032 -10.9608 11.0673 -2168 4 8.54203 29.0732 32.4131 7.8922 -1.0693 -1.41065 -2169 6 17.6887 41.2397 36.4833 -13.2152 -10.2381 33.1554 -2170 4 16.9194 41.8027 36.6113 -2.7651 1.17246 3.809 -2171 4 17.9462 41.408 35.602 16.1966 5.46369 -29.7656 -2172 6 28.4973 24.2486 15.5471 -12.6583 -10.112 -30.4241 -2173 4 29.1017 24.9078 15.1992 6.65529 6.29726 4.69488 -2174 4 28.2904 23.7156 14.7389 1.39534 3.17619 21.4563 -2175 6 20.9519 16.2974 1.15248 44.1264 9.982 -6.69009 -2176 4 20.9895 15.4004 1.43432 -0.0798072 -22.9414 11.198 -2177 4 20.0538 16.5254 1.09156 -44.6028 7.62895 -2.50253 -2178 6 31.1717 40.7384 5.29995 -1.14335 -24.9234 -14.6262 -2179 4 30.3101 40.4535 4.98914 0.542473 -7.39845 -0.335603 -2180 4 31.0069 41.6267 5.54556 -2.10438 36.1837 12.2935 -2181 6 29.9172 24.7601 36.4536 2.52587 12.7881 -5.39704 -2182 4 30.4095 25.4459 35.9567 -7.35112 -4.48214 8.13095 -2183 4 30.0744 23.9625 35.9621 2.47343 -16.947 -5.4104 -2184 6 8.66853 31.0461 3.90506 3.77884 -22.5587 -9.29968 -2185 4 7.73756 30.8263 3.92016 -7.28297 1.54323 -1.95967 -2186 4 8.75192 31.9258 4.24445 1.80419 26.3875 10.0131 -2187 6 5.53845 32.6958 11.4143 8.71933 -16.8124 -2.49586 -2188 4 4.77303 33.2403 11.6664 3.11219 -11.1916 -2.75881 -2189 4 5.22904 31.759 11.32 0.456358 25.4252 4.80969 -2190 6 45.6505 35.4572 20.4414 3.44959 -7.44503 -2.03407 -2191 4 45.0984 35.4295 19.6379 6.4013 -0.712815 7.57821 -2192 4 46.1919 34.6303 20.4513 -12.6908 13.7486 -3.45541 -2193 6 19.5117 2.78375 9.7759 -32.3978 -9.59039 -17.0694 -2194 4 19.2358 3.70482 9.71872 -0.134373 3.8207 4.89971 -2195 4 18.7417 2.29322 9.36028 25.7327 11.9734 13.3495 -2196 6 54.9587 9.07031 10.9149 6.82732 -5.63024 12.2566 -2197 4 54.8294 8.9199 11.8667 -4.4018 -2.06217 -5.32285 -2198 4 0.663346 9.73371 10.8556 1.49355 -0.124783 -2.42855 -2199 6 21.0387 26.5729 14.7801 20.1883 -1.49652 -44.4677 -2200 4 21.3075 26.2685 13.8316 -13.9911 15.8829 47.28 -2201 4 20.1009 26.3915 14.9175 1.72514 -4.1332 -5.78598 -2202 6 14.1556 30.5195 27.5512 33.9559 3.86758 5.7066 -2203 4 14.6157 30.1887 28.3748 -9.20473 8.28645 -28.3289 -2204 4 14.8625 30.9321 26.9648 -24.7422 -11.1229 20.6028 -2205 6 29.8153 17.3336 31.0863 -17.242 12.2647 2.89366 -2206 4 30.6608 17.508 30.6961 22.1461 -2.37775 -6.86255 -2207 4 29.3509 18.1813 30.9961 -0.156979 -6.11616 8.89085 -2208 6 50.8803 17.2897 27.8178 -36.3925 19.5692 4.68662 -2209 4 49.966 17.6961 27.8739 30.6942 -17.822 -8.40051 -2210 4 51.3989 17.8346 28.4178 4.99425 -5.86793 -0.268148 -2211 6 46.2649 37.0836 13.9834 -5.2064 -3.89214 -29.9265 -2212 4 46.1297 37.5324 14.8008 -1.4234 12.1478 29.9589 -2213 4 45.6025 37.4999 13.3985 5.55615 -7.46483 0.310394 -2214 6 38.1938 37.2652 33.1426 -7.30823 -21.5307 12.8964 -2215 4 38.5245 37.3061 34.0621 0.43181 3.22683 -10.2889 -2216 4 38.5338 38.0078 32.6437 8.99657 15.0472 -1.17828 -2217 6 41.835 13.3432 31.1173 -10.6585 13.9874 21.8211 -2218 4 41.5818 13.8647 31.919 4.55225 -14.0949 -20.2689 -2219 4 42.3932 12.6177 31.4161 6.34511 -7.13184 -1.29627 -2220 6 46.8964 12.6581 17.833 -7.85032 10.4907 -16.4819 -2221 4 46.6484 13.6178 17.7542 4.08188 -24.8978 -7.40371 -2222 4 46.6377 12.1709 16.9987 5.46876 16.7046 19.0746 -2223 6 32.0579 10.0934 10.6503 -8.64381 28.9058 -4.43215 -2224 4 31.7849 9.65569 11.4853 0.173068 15.3159 -11.0765 -2225 4 31.7767 11.0763 10.6467 12.4785 -48.8318 10.7993 -2226 6 34.0094 11.373 6.75969 12.8388 24.8548 11.4886 -2227 4 33.4875 10.5861 6.69386 -15.1181 -21.0438 1.83339 -2228 4 33.7853 11.7772 7.62543 1.85262 -6.17932 -11.7084 -2229 6 45.3294 30.8612 19.494 8.3992 -12.4908 2.66791 -2230 4 45.3133 30.6326 20.4263 -2.2594 2.91399 10.7741 -2231 4 45.8271 30.1094 19.1443 -2.81922 5.63857 -5.34771 -2232 6 20.3557 0.57205 7.14927 -0.865045 4.87397 8.36509 -2233 4 20.1887 0.590785 8.10086 -2.30268 5.48708 -2.96522 -2234 4 20.2885 41.5556 6.94299 -1.24307 -13.5357 -7.1472 -2235 6 15.9783 39.4524 4.13892 -0.0151964 -9.48015 -5.29824 -2236 4 15.6158 39.9898 3.41173 1.6648 1.85694 12.5404 -2237 4 15.64 39.7774 4.99485 -4.20756 5.15612 -10.0141 -2238 6 52.4256 16.4667 25.1127 -17.0507 13.8269 -2.02364 -2239 4 51.8848 16.9346 25.7614 0.982734 -7.60925 5.82434 -2240 4 52.3383 17.0704 24.353 8.48557 -12.5426 -0.219872 -2241 6 38.5361 13.0039 3.23845 15.1533 54.069 38.768 -2242 4 38.651 13.64 4.04305 -2.16968 -28.4467 -44.0011 -2243 4 38.0019 12.309 3.58724 -16.6469 -22.8542 0.297491 -2244 6 35.13 29.6899 31.1766 -32.8294 1.63854 50.8714 -2245 4 35.4825 30.1651 30.4465 16.0479 15.276 -26.3528 -2246 4 34.6741 30.3613 31.7643 12.1102 -21.125 -19.7306 -2247 6 9.51973 33.7498 4.86217 -21.8826 5.77433 4.68556 -2248 4 9.27059 34.3826 5.57285 8.50621 -13.5655 -12.6408 -2249 4 10.3866 33.3952 5.041 8.90701 -1.44023 3.12186 -2250 6 21.534 22.0642 20.5279 -11.3341 -5.53839 17.2976 -2251 4 20.8989 22.7675 20.339 3.51908 1.76985 -0.685914 -2252 4 21.3133 21.7346 21.437 6.74336 6.48682 -22.5749 -2253 6 37.579 11.1901 41.2936 -40.5688 -13.8213 19.6839 -2254 4 37.9154 11.8125 40.6731 20.8822 18.4609 -22.3708 -2255 4 38.2848 10.6639 41.6667 19.2795 -3.39896 1.21846 -2256 6 33.8862 1.42431 38.7362 -9.76991 -12.243 -0.11253 -2257 4 33.6023 0.553369 38.4181 2.20193 5.31751 1.25532 -2258 4 33.9041 1.3558 39.7008 -0.574955 5.51976 -3.65617 -2259 6 4.57166 26.6812 27.9899 28.8485 -45.5436 -4.48952 -2260 4 5.15229 25.8908 28.1565 -23.3183 20.9594 -13.553 -2261 4 4.90489 27.293 28.6243 -0.866291 24.6335 11.5543 -2262 6 10.2514 0.902381 11.6154 -4.58149 -17.6537 26.8062 -2263 4 10.6592 1.12475 12.4668 -4.26503 -7.612 -8.38981 -2264 4 10.5004 1.60734 11.0484 5.83944 23.9466 -26.0443 -2265 6 17.6545 19.8255 2.35686 18.7122 -0.118329 6.29025 -2266 4 17.9031 20.43 1.64019 0.754008 -4.0492 2.7955 -2267 4 18.4832 19.3436 2.60738 -15.0404 10.1651 -4.64219 -2268 6 32.418 25.6758 16.4635 3.6076 24.4214 11.9097 -2269 4 33.0171 26.0095 17.1449 -9.06157 4.09224 -4.99535 -2270 4 32.7904 24.838 16.2462 -1.14602 -28.0291 -11.1265 -2271 6 33.2468 10.6359 0.32388 9.93322 -26.76 -6.12289 -2272 4 32.8861 10.0042 41.5485 10.341 19.2926 16.9559 -2273 4 34.0854 10.2367 0.697563 -23.7256 11.8288 -10.1734 -2274 6 4.94758 4.52061 10.1416 10.7499 4.98188 17.9077 -2275 4 4.04768 4.863 10.1726 -0.273394 -4.88493 2.42241 -2276 4 5.29522 4.53942 11.0694 -10.4701 1.63881 -23.2648 -2277 6 27.0943 16.9779 9.5563 -20.4641 3.47693 -11.2288 -2278 4 27.2045 17.5151 10.3493 -1.38601 2.5137 2.70549 -2279 4 26.2214 17.2494 9.17658 21.4447 -4.2653 12.7286 -2280 6 9.99194 10.5198 19.3763 9.42123 -1.05348 44.8422 -2281 4 10.4342 9.89794 18.8118 9.85784 -12.5922 -17.5865 -2282 4 10.1605 10.162 20.3013 -9.67835 15.4527 -31.558 -2283 6 19.5738 8.53792 27.8563 25.8928 -1.13542 15.4327 -2284 4 20.113 8.77024 28.6584 -12.6361 -5.62488 -23.922 -2285 4 20.1113 7.87775 27.3567 -13.5748 14.3815 9.08869 -2286 6 47.0629 38.9588 23.1271 -13.9792 1.44752 0.432651 -2287 4 47.6691 38.8737 22.3925 4.22694 -4.47738 -4.61135 -2288 4 46.1776 38.8683 22.7344 3.33277 3.24373 3.79368 -2289 6 19.6833 25.3678 11.2608 -44.4501 -0.725843 0.650565 -2290 4 19.0139 24.6272 11.3182 24.6346 19.551 -2.60477 -2291 4 19.1544 26.1629 11.5326 10.4738 -19.1562 -5.87093 -2292 6 27.3884 13.4531 15.7313 17.4935 -10.3398 7.87305 -2293 4 26.7289 13.8255 16.2909 -22.225 11.7393 10.4827 -2294 4 28.1076 13.2654 16.3619 5.43008 -3.78237 -14.8549 -2295 6 18.6476 14.1287 1.42435 5.12245 -4.46092 -43.403 -2296 4 18.3969 15.043 1.25229 -6.07889 7.26273 6.76186 -2297 4 19.169 13.9274 0.593091 -12.995 -1.5013 29.2583 -2298 6 42.2956 22.0175 32.4812 -31.5033 5.69606 -11.9689 -2299 4 42.0953 21.6028 33.3343 -5.26012 -0.0861087 1.91793 -2300 4 41.4492 22.4721 32.2087 27.3869 -15.7461 8.96812 -2301 6 10.0338 9.4525 2.5044 21.0744 -25.1182 9.26795 -2302 4 9.23419 9.82009 2.8603 -22.4046 15.9317 4.21557 -2303 4 10.2146 8.68383 3.09556 -0.513225 11.8796 -14.6695 -2304 6 6.81454 1.43994 21.9965 -17.8896 2.42247 -7.4431 -2305 4 5.91626 1.63042 21.618 24.8197 -16.2049 7.25345 -2306 4 7.09146 0.513113 21.8391 -15.5061 11.1514 -4.64506 -2307 6 11.279 27.0428 18.9739 -2.94846 37.5248 -0.887691 -2308 4 11.8405 27.0241 19.773 -2.49358 0.901506 -7.48985 -2309 4 11.2189 28.0198 18.7087 3.35633 -32.7966 13.2637 -2310 6 41.4624 20.5117 27.2131 -8.71247 23.609 -19.3396 -2311 4 41.6397 21.203 27.8749 -2.09795 -12.5822 -0.139714 -2312 4 41.4581 19.6661 27.6488 3.25287 -9.08293 14.2442 -2313 6 15.4472 24.107 33.4286 7.47915 5.78269 -2.8589 -2314 4 14.6947 24.3175 34.0087 6.10264 -6.26217 -2.67023 -2315 4 15.704 23.1687 33.5026 -8.54671 4.87938 10.939 -2316 6 36.1332 16.3778 10.0175 -2.81296 8.13669 8.31829 -2317 4 36.0433 15.4982 9.63146 0.0153009 -3.05325 1.23302 -2318 4 36.1908 16.2895 10.9807 1.05799 -3.5475 -8.17119 -2319 6 51.7056 16.2618 2.12066 8.195 -18.8618 -27.7488 -2320 4 51.3212 16.7491 2.82948 -13.5116 6.32013 30.1636 -2321 4 51.8333 15.3227 2.36395 -2.62212 15.8907 6.5854 -2322 6 23.4154 8.54771 39.774 19.4785 -4.07885 -14.0827 -2323 4 23.6619 8.92799 38.8876 -4.40964 -10.2511 30.1282 -2324 4 24.1933 8.06554 40.1323 -10.8686 15.1901 -10.9325 -2325 6 36.7652 34.4407 21.0996 -10.7203 -4.0633 -8.35763 -2326 4 37.1575 34.5988 20.2292 -2.24352 0.118594 1.89686 -2327 4 35.7922 34.4168 20.9564 13.0606 -0.027129 3.88767 -2328 6 14.1394 8.88964 27.2822 8.4001 33.0473 -16.3093 -2329 4 13.5583 8.17177 27.4325 -25.1847 -27.8879 6.89622 -2330 4 14.9981 8.62308 27.6007 12.278 -0.771553 4.38 -2331 6 20.6523 37.4857 25.1916 -4.76336 -9.80096 2.89409 -2332 4 20.8435 36.6327 24.7231 -2.60537 24.8018 1.29013 -2333 4 20.5883 38.2205 24.557 2.95927 -14.0914 0.587832 -2334 6 28.8259 24.466 30.0361 -12.0182 1.20484 18.6414 -2335 4 28.1863 24.5363 29.306 15.5663 0.0495978 -2.57679 -2336 4 29.6571 24.0617 29.7579 -0.701354 -5.27936 -13.535 -2337 6 8.3767 11.9994 23.6977 15.286 -11.9681 20.7139 -2338 4 9.3753 12.0245 23.8359 -31.6027 -4.22616 -3.50543 -2339 4 7.96209 11.4264 24.4013 16.8905 14.3689 -13.5243 -2340 6 16.0974 26.6628 22.9497 0.767107 4.93659 2.67852 -2341 4 16.422 25.9025 22.452 -4.69466 0.466105 1.02544 -2342 4 15.3072 26.4353 23.4595 5.90508 -1.9072 -2.1838 -2343 6 22.3492 41.3933 9.48833 17.1541 -15.2597 3.14364 -2344 4 22.6076 0.330473 9.13574 5.89797 15.5422 -4.87712 -2345 4 21.4389 41.4869 9.73785 -21.2641 2.73615 1.78898 -2346 6 49.3865 19.1849 32.379 28.5034 -27.5288 -8.8444 -2347 4 49.9591 18.5119 32.8294 -20.0237 22.3317 -7.01358 -2348 4 48.8882 19.6696 33.032 -5.7885 3.32597 15.4548 -2349 6 29.6797 28.4194 31.2347 -18.17 -6.54897 12.3532 -2350 4 30.6054 28.3362 30.9452 0.112823 -13.8933 8.50124 -2351 4 29.3632 27.6339 31.7874 27.6893 19.0339 -22.4607 -2352 6 5.1089 39.1304 23.5821 16.3589 -26.7425 38.52 -2353 4 5.38369 38.72 24.4786 -14.1195 25.2427 -41.8592 -2354 4 5.12138 40.0884 23.679 1.29424 5.88982 9.05127 -2355 6 42.9406 13.5828 41.5963 2.4548 -20.3274 5.45752 -2356 4 42.752 14.3543 41.1051 4.71299 30.6973 -25.311 -2357 4 42.1302 13.4831 0.159852 -12.9765 -12.2431 17.3873 -2358 6 21.226 12.4267 7.36435 31.2446 -3.521 -2.03074 -2359 4 20.2961 12.4647 7.18572 -19.4619 -2.59914 -12.879 -2360 4 21.5838 11.6146 6.96487 -5.92297 6.31526 1.33966 -2361 6 43.1402 26.8798 37.6925 36.8226 -18.0871 25.2922 -2362 4 42.3701 26.4861 37.2457 1.92095 -10.9538 3.42147 -2363 4 43.8051 26.2366 38.1772 -44.9135 25.1765 -29.4158 -2364 6 19.5374 10.6589 41.6895 -5.57828 -38.0023 -10.1688 -2365 4 19.1336 10.6448 0.637369 -6.5477 2.89313 17.0607 -2366 4 19.8005 11.5407 41.5226 10.6711 39.664 -4.3781 -2367 6 53.6211 10.0725 3.2523 6.57913 5.47914 -9.18923 -2368 4 54.2317 10.83 3.34927 -4.54537 -9.93589 0.0420736 -2369 4 54.0384 9.44833 2.62164 -2.29754 8.8252 9.03809 -2370 6 17.5636 20.1992 28.4305 -16.5699 17.1528 15.5915 -2371 4 18.0548 19.7019 27.7957 9.40873 -10.9714 -15.8242 -2372 4 18.1497 20.2955 29.1876 1.50874 1.07066 2.83373 -2373 6 36.8673 7.33814 1.69171 -42.7001 9.70605 -8.47937 -2374 4 37.6788 7.60022 2.09727 18.2611 10.2246 9.26811 -2375 4 36.4242 8.16776 1.39628 11.5951 -12.345 5.16871 -2376 6 29.225 41.4226 1.83075 -19.1389 21.107 -1.05665 -2377 4 28.4254 0.0289368 2.09685 16.3458 -11.1471 3.47601 -2378 4 29.1672 41.4088 0.871311 7.531 -2.47214 -5.14574 -2379 6 13.5148 3.09025 8.11784 -10.8355 13.5741 -3.86075 -2380 4 12.8447 3.80664 8.08285 8.27234 -10.6709 -2.48032 -2381 4 13.8247 3.09872 9.02804 1.30446 -5.60755 1.07776 -2382 6 15.035 29.5824 18.5052 -13.3664 3.09019 -9.07378 -2383 4 14.628 28.8743 17.9722 6.78876 3.62049 6.93265 -2384 4 14.2975 30.1967 18.6986 12.8362 -2.82157 -1.1162 -2385 6 10.5118 24.7077 24.3903 18.3301 23.9761 -31.3173 -2386 4 10.707 24.7057 23.4146 -4.2845 7.89501 28.372 -2387 4 10.0612 23.8909 24.4849 -17.9274 -27.8 13.6507 -2388 6 2.3293 13.8562 25.1542 8.14415 -2.44132 2.05706 -2389 4 1.63302 13.4321 24.6436 -3.32338 -7.08116 -5.4939 -2390 4 2.0923 14.7815 25.112 -7.52471 9.11743 -0.122921 -2391 6 31.8571 32.759 29.7983 3.65167 10.3578 -8.56752 -2392 4 30.9277 32.9381 29.9784 -0.622435 -3.80813 0.732423 -2393 4 31.8884 31.8723 29.4276 -3.71181 -5.10697 -2.58235 -2394 6 37.531 40.8209 33.967 -23.153 -16.1875 5.3836 -2395 4 37.3251 40.1347 34.6985 0.870468 26.6491 -35.3147 -2396 4 36.773 40.8784 33.3102 18.3716 -9.25033 25.8989 -2397 6 24.0485 38.1313 34.3431 -11.5105 1.837 -35.773 -2398 4 24.1907 38.198 35.2802 9.24451 -7.73664 19.5979 -2399 4 24.4675 37.3552 33.934 1.62169 3.10325 14.1331 -2400 6 37.1852 22.5711 7.36841 5.54302 -17.8805 15.7599 -2401 4 37.6193 21.7136 7.5635 -9.24307 15.2983 -3.07678 -2402 4 37.2973 22.7156 6.43503 3.10694 -1.55352 -15.3513 -2403 6 4.30637 23.241 35.6005 -21.8515 -3.12039 0.833232 -2404 4 4.28153 22.3978 35.1252 -1.17938 4.50836 1.52069 -2405 4 3.36633 23.5034 35.7569 13.5984 -2.36814 -1.35472 -2406 6 15.7372 14.8984 2.68389 5.83394 8.18523 30.6602 -2407 4 16.0581 15.8209 2.80401 -5.66096 -17.7803 -6.78984 -2408 4 15.4195 14.7671 1.79524 0.865375 8.28049 -11.4308 -2409 6 48.1667 23.1873 2.04358 2.14857 -5.2771 -14.5053 -2410 4 48.6748 23.4267 2.82287 11.4848 0.866046 3.26637 -2411 4 48.7964 22.9219 1.32588 -13.3162 5.875 14.6145 -2412 6 24.1221 19.9752 21.5371 -32.3717 23.6383 6.86593 -2413 4 24.143 19.3917 22.3107 11.6246 -2.80692 -10.3828 -2414 4 24.7866 19.7762 20.8968 22.5091 -14.1667 -7.68302 -2415 6 10.5822 29.3968 5.14403 -6.21678 -11.6361 15.7318 -2416 4 9.83188 29.7897 4.67624 10.1791 9.93667 -6.35089 -2417 4 11.4324 29.7717 4.90568 -2.60747 8.99296 -10.7541 -2418 6 5.96985 27.6957 31.2251 14.0826 -21.4471 -14.909 -2419 4 6.62108 27.1001 30.7651 -15.2176 13.0885 7.83628 -2420 4 6.49554 28.1541 31.8886 3.5811 4.10899 4.91189 -2421 6 18.524 25.7945 15.3346 -6.80319 -1.26411 -41.3947 -2422 4 18.3129 25.8537 16.2191 -1.03447 -6.47723 71.4836 -2423 4 17.8509 26.3975 15.0287 -5.96066 9.61194 -22.438 -2424 6 52.0911 37.2147 11.1191 10.7944 -12.7592 -3.2574 -2425 4 52.6735 36.5031 10.7991 -6.06835 6.24709 5.19982 -2426 4 52.6754 37.9802 11.2539 -6.64808 -1.57102 -0.449092 -2427 6 46.8545 14.6154 7.32174 -10.4102 9.08531 6.17155 -2428 4 46.1761 15.2305 7.76384 29.9054 -34.6086 -7.32766 -2429 4 47.196 13.9114 7.91569 -13.0839 18.0399 0.731203 -2430 6 22.2426 0.701706 41.6733 41.1626 12.534 -29.9538 -2431 4 22.236 1.66756 41.6378 -9.79705 -6.68715 4.90956 -2432 4 23.0808 0.492341 41.1545 -29.2322 -0.545859 23.5967 -2433 6 4.06645 14.7285 9.26505 -5.79968 22.7562 -12.5209 -2434 4 3.53709 15.5501 9.07402 9.13976 -21.8289 3.48331 -2435 4 4.94549 14.9564 8.94351 2.1847 -1.50717 0.750146 -2436 6 37.293 12.6643 37.0348 -15.3153 -6.18171 16.0178 -2437 4 37.7524 12.8164 37.9019 -17.8573 -2.14895 -9.99561 -2438 4 36.3666 12.3049 37.1727 33.7628 8.85249 1.83374 -2439 6 26.6624 29.0693 40.5955 -26.637 27.4899 13.7151 -2440 4 27.0962 28.2693 40.8235 19.1059 -29.7051 -2.9078 -2441 4 26.7436 29.2635 39.6647 9.93266 -1.33043 -11.4317 -2442 6 7.23743 13.8563 3.32048 -33.1041 -30.3754 -14.41 -2443 4 7.96064 14.4301 3.56742 25.5688 -7.52041 0.820923 -2444 4 7.42976 12.8854 3.09984 6.81051 43.2082 15.4509 -2445 6 8.94797 34.8532 28.8254 23.4184 -23.2786 -12.4265 -2446 4 9.89546 35.0323 28.6727 -12.7097 -5.00209 3.03018 -2447 4 8.59604 35.6886 29.0779 -14.3686 23.8739 12.2374 -2448 6 37.2014 40.0808 40.1141 12.7521 0.43192 13.6168 -2449 4 36.2619 40.0837 39.9632 -10.4254 2.72875 -6.67898 -2450 4 37.248 39.4512 40.8496 7.71934 0.19736 -2.65382 -2451 6 30.3728 6.17428 27.2502 2.34222 12.9127 24.6773 -2452 4 30.0491 5.75377 28.1093 17.5599 21.8776 -23.7977 -2453 4 31.0277 6.90628 27.4549 -18.5498 -22.5685 3.02853 -2454 6 10.4851 22.8816 18.2947 -6.39025 -14.7202 -25.3901 -2455 4 11.3539 23.0451 18.66 8.78619 -1.44678 0.615593 -2456 4 10.601 22.3432 17.4702 -0.435219 15.7289 22.4338 -2457 6 35.9047 14.2516 40.1476 -11.9566 8.08227 -8.12446 -2458 4 35.3828 14.5983 39.4171 17.9635 11.5828 -3.36223 -2459 4 35.2535 13.6726 40.504 -8.36759 -16.975 21.7169 -2460 6 6.70775 1.0715 17.7189 7.50642 -21.2746 -7.36561 -2461 4 6.22784 1.34485 18.5084 1.44497 -10.5234 3.95628 -2462 4 6.91772 0.0894674 17.7256 -13.4419 30.1572 13.7277 -2463 6 41.3365 34.0623 33.1636 23.1157 -5.84267 13.8333 -2464 4 40.4227 34.234 32.9444 -15.3258 11.3352 -14.6542 -2465 4 41.9184 34.5849 32.5841 -12.4833 3.91505 -3.84565 -2466 6 37.2858 0.99342 41.2878 7.36827 13.3221 -16.8172 -2467 4 37.4859 0.112276 40.9658 -1.88555 -12.2628 0.361589 -2468 4 37.4834 1.0172 0.312287 5.29267 -3.40266 15.6364 -2469 6 25.2541 30.9749 6.2071 -22.7336 2.5299 17.3506 -2470 4 26.0217 31.2424 5.69829 1.89843 -3.96463 -15.2281 -2471 4 24.4182 30.8551 5.69564 23.045 5.74277 3.20871 -2472 6 14.1871 24.4929 28.313 -6.35756 40.4048 -1.58139 -2473 4 14.3311 23.6816 28.7714 -3.10946 -31.1704 -0.0360927 -2474 4 13.792 24.4319 27.4273 2.40698 -14.1025 6.50138 -2475 6 34.2078 26.2332 36.0169 -41.3887 31.6455 20.302 -2476 4 35.1375 26.2713 36.1926 18.3831 1.21525 6.50399 -2477 4 33.7458 26.9646 36.5669 26.0782 -29.6148 -21.0343 -2478 6 32.3696 8.32545 27.9988 -31.7689 14.924 14.5852 -2479 4 32.5206 9.30939 28.0669 10.5891 -30.1429 -9.37737 -2480 4 33.1235 7.86931 27.6333 20.3768 10.5357 -6.59273 -2481 6 11.7881 0.276326 26.9686 -1.26514 -24.1343 -2.09554 -2482 4 11.7898 41.2288 26.6922 -1.19404 21.3361 9.01519 -2483 4 11.5977 0.31005 27.9205 2.09711 -1.6438 -10.9729 -2484 6 1.68282 0.256654 10.3371 7.78574 -7.1909 -12.7427 -2485 4 1.59984 41.2742 10.69 -0.913761 -2.35777 -0.20094 -2486 4 1.41183 0.821253 11.0453 -5.61238 10.3042 16.839 -2487 6 6.75659 13.8554 8.24275 2.15336 8.75665 -12.4729 -2488 4 6.4538 13.9004 7.29654 11.603 6.79512 25.9161 -2489 4 7.29723 14.6482 8.44053 -3.39366 -6.31817 -8.96948 -2490 6 22.229 20.5516 6.16712 -19.4021 -6.23502 11.2792 -2491 4 21.7175 21.3783 6.29668 6.22315 -10.0472 -0.391558 -2492 4 21.7004 19.8262 6.58709 9.33903 15.1246 -7.94106 -2493 6 17.3809 20.4508 10.8712 -6.33142 3.08518 -4.04876 -2494 4 16.5461 20.08 10.4568 21.8919 23.129 5.85777 -2495 4 17.5363 21.4129 10.6625 -13.97 -26.3983 1.7074 -2496 6 17.7006 4.52466 19.5892 5.66371 -4.97651 -9.86024 -2497 4 16.9376 4.52739 20.1892 -4.06273 -5.34645 -7.80596 -2498 4 17.5412 3.84457 18.8839 -0.885651 16.9891 23.3258 -2499 6 0.475545 18.1168 40.0844 5.30586 -7.45209 -16.0452 -2500 4 0.255658 18.7395 40.7612 -0.602959 14.3131 10.4938 -2501 4 1.33302 18.3868 39.7002 -7.70736 -6.31105 3.74686 -2502 6 22.9439 24.8338 27.8349 -3.23408 23.09 -51.7359 -2503 4 22.7283 25.5292 27.1178 5.97449 -27.0764 31.3639 -2504 4 22.8278 25.2464 28.677 -4.11703 14.8593 21.0934 -2505 6 42.7959 39.1553 26.7627 -13.6288 14.9904 24.3142 -2506 4 42.9559 38.4383 26.1586 10.7263 -7.78522 -15.113 -2507 4 43.351 39.9224 26.5692 3.77188 -7.24305 -5.18193 -2508 6 26.2354 3.05796 21.7982 1.74018 25.1467 -10.7915 -2509 4 25.6923 3.78105 22.1642 10.9011 -13.8467 -3.1836 -2510 4 26.7888 3.50003 21.1142 -10.0122 -11.5362 10.4851 -2511 6 54.6007 9.88011 29.5829 2.61324 -0.835643 16.9334 -2512 4 53.983 9.1383 29.6239 1.49377 0.577448 -2.59463 -2513 4 54.746 10.0983 30.5296 -2.21833 -1.79811 -18.9561 -2514 6 24.7578 33.7363 20.5387 -17.5006 5.04967 -0.0763559 -2515 4 24.6934 34.6555 20.8512 7.60819 -4.12262 3.6003 -2516 4 23.9235 33.6132 20.0554 5.3121 -3.42637 -1.44671 -2517 6 41.6963 16.3109 0.897802 2.88421 10.066 -28.0255 -2518 4 41.3077 16.0362 1.70176 -16.3219 -5.78099 30.2108 -2519 4 42.6299 16.1901 1.06805 12.6035 -3.11322 -2.97519 -2520 6 23.404 27.9303 27.4821 -1.06023 20.2241 -21.3645 -2521 4 22.8141 28.2554 28.1835 2.551 -1.87769 -8.73241 -2522 4 23.2629 28.4828 26.6516 2.17993 -16.4871 31.3925 -2523 6 32.7813 37.2936 18.7328 38.5641 -14.7697 6.75932 -2524 4 33.752 37.1016 18.9061 -34.9795 -0.437252 0.892363 -2525 4 32.8311 38.1729 18.3762 -6.70298 14.6722 -8.07554 -2526 6 21.2305 27.6771 4.7955 -18.4608 -25.795 -24.9287 -2527 4 20.5062 27.4644 5.39651 2.92048 5.31567 1.45057 -2528 4 20.941 27.2184 3.94502 12.5509 18.4099 23.8236 -2529 6 54.9409 17.9571 1.83459 -7.07205 6.42915 6.55936 -2530 4 54.7029 17.1381 1.42965 7.06691 -21.815 -7.49321 -2531 4 54.119 18.4405 1.74821 -9.38537 8.8513 -0.363257 -2532 6 36.7335 10.6984 6.58912 -34.5362 -0.324761 -4.53473 -2533 4 35.7609 10.9799 6.6143 34.1258 -12.1011 2.72213 -2534 4 36.7696 9.77633 6.90859 -3.13742 6.31851 -1.30765 -2535 6 54.2706 4.50024 14.0257 -11.269 5.99606 -15.4247 -2536 4 53.8536 5.11876 13.3604 4.87759 -11.992 26.1673 -2537 4 53.895 4.59469 14.9192 -3.76531 8.72829 -7.53187 -2538 6 22.107 12.8255 32.0148 27.0088 -6.82073 4.3703 -2539 4 21.2061 13.1328 31.8952 -10.7145 6.62508 -9.34344 -2540 4 22.7298 13.2576 31.3917 -17.4011 -3.99159 8.00208 -2541 6 15.2931 36.6619 4.04206 -24.4039 12.3238 20.1693 -2542 4 15.3606 37.6342 3.9855 6.08423 -9.62309 -2.22716 -2543 4 16.0243 36.2999 3.55051 12.1414 -1.28609 -8.9598 -2544 6 23.9518 1.27347 5.70825 1.82336 16.8815 15.3992 -2545 4 23.158 0.731739 5.71694 -5.31944 -7.03749 -3.2154 -2546 4 23.9846 1.73289 6.57368 -1.26671 -8.46254 -14.2674 -2547 6 14.3069 12.6571 15.8074 -11.3886 -13.8779 -22.9988 -2548 4 14.4908 12.4438 14.8835 17.1875 4.58775 1.43504 -2549 4 13.3991 12.3171 15.8566 5.60683 8.95198 18.2444 -2550 6 15.0463 40.2277 6.58272 -14.4539 15.1029 5.15073 -2551 4 15.8086 40.489 7.08192 22.3652 -6.01515 7.9389 -2552 4 14.4962 41.022 6.75392 -6.77819 -16.9793 -13.6053 -2553 6 48.5629 32.6194 12.091 2.37027 -5.84764 -3.4739 -2554 4 48.1048 31.8776 11.6348 7.57669 12.4587 1.43975 -2555 4 49.3373 32.9111 11.5511 -18.0393 -12.2542 5.39731 -2556 6 11.2883 31.5349 7.21941 -5.75599 -10.1169 -16.3625 -2557 4 10.675 30.8987 6.79271 12.7122 10.5617 8.56414 -2558 4 11.681 32.0415 6.48473 -4.52974 -6.63428 7.17241 -2559 6 30.1204 27.9925 10.216 2.65146 5.67665 0.571004 -2560 4 30.7332 28.7325 10.019 -7.63861 -11.6097 -0.594568 -2561 4 29.9063 27.5181 9.39417 2.857 4.22172 -1.33476 -2562 6 27.6817 22.1076 17.3717 2.13561 -8.21554 7.46684 -2563 4 27.3138 21.4721 16.7296 5.88092 9.15558 -3.1228 -2564 4 28.0594 22.8778 16.9197 -3.27829 -5.84867 -5.86393 -2565 6 12.9588 4.5965 18.1625 2.45174 -26.8216 -12.137 -2566 4 13.4346 3.75914 18.3684 -5.38503 16.4797 0.486183 -2567 4 12.5704 4.4145 17.2814 1.35975 11.1796 8.84538 -2568 6 19.7171 6.72206 19.0824 18.7149 18.1076 8.78634 -2569 4 19.0276 6.07043 19.1643 -12.8479 -14.7766 2.48779 -2570 4 20.149 6.78349 19.9504 -8.03044 -1.70313 -8.42964 -2571 6 37.158 31.386 11.4948 13.5333 -6.17925 -0.534196 -2572 4 36.3748 31.5241 12.0574 10.6691 -10.2998 8.4252 -2573 4 37.8298 30.7884 11.9154 -26.2348 9.80485 0.777976 -2574 6 3.12167 16.2038 27.3537 -19.2499 -26.3416 -14.9115 -2575 4 2.564 15.4232 27.613 17.9651 21.4634 -3.17821 -2576 4 3.05771 16.2343 26.3741 -0.0558506 5.44355 20.7735 -2577 6 15.7152 9.97508 38.3617 37.2659 20.4939 22.6587 -2578 4 16.1689 10.8384 38.1525 -17.0523 -25.976 5.55091 -2579 4 16.2475 9.64647 39.1327 -18.0975 2.21635 -20.7757 -2580 6 13.3945 14.2914 8.22355 52.7406 24.0557 20.8129 -2581 4 13.9343 15.0997 8.53617 -32.8018 -27.7376 -11.9171 -2582 4 14.0669 13.5802 8.35008 -24.0553 1.67412 -6.96019 -2583 6 1.72299 24.3133 36.3936 32.5837 -28.3335 21.1288 -2584 4 1.96116 25.1215 36.8464 -1.44419 12.4956 -1.11134 -2585 4 1.10799 24.5417 35.7277 -24.491 15.1488 -24.3141 -2586 6 11.1925 26.5189 32.9725 1.88857 3.23229 20.5962 -2587 4 10.9062 26.8258 32.1286 -6.138 -2.28585 -27.1412 -2588 4 11.0637 27.2989 33.5293 3.02186 -7.15206 7.83107 -2589 6 29.5898 0.769141 36.29 0.770047 10.6645 18.3277 -2590 4 29.1085 0.54227 35.5145 -3.81283 -13.529 -27.0487 -2591 4 28.8904 1.11515 36.8518 6.86702 4.29265 4.12775 -2592 6 43.6054 13.1224 23.9122 -2.46968 6.93561 -17.1322 -2593 4 42.8447 13.3401 24.4619 -4.47847 1.10283 0.728731 -2594 4 43.3126 13.2067 22.9653 4.50753 -0.208477 27.3689 -2595 6 7.45217 19.7807 19.6677 5.33955 -1.6221 -12.877 -2596 4 6.80427 19.1226 19.9251 -3.45906 -4.13396 8.35684 -2597 4 7.46466 19.745 18.7046 0.226191 5.91599 3.73904 -2598 6 24.4186 4.28854 7.83154 -9.27237 -3.93777 -5.86373 -2599 4 24.1141 5.19611 7.95791 2.72117 -5.11917 -0.666563 -2600 4 25.0574 4.07609 8.5187 1.73531 2.38301 -0.0162684 -2601 6 51.4783 30.2365 31.1578 4.43663 8.1051 17.8753 -2602 4 50.5719 29.9409 31.3316 -1.01079 -0.531629 -9.26743 -2603 4 51.6665 30.2531 30.2149 -6.58635 -1.64064 -12.0931 -2604 6 0.928618 23.6677 16.8891 39.1558 -2.20072 16.2176 -2605 4 0.0728448 23.4362 16.5368 -6.93512 -13.3273 -6.91209 -2606 4 1.45563 22.867 17.1505 -20.9828 13.2836 -9.64814 -2607 6 45.0876 19.3948 15.692 7.86589 27.8079 -34.4593 -2608 4 45.9117 18.9264 15.546 6.38244 -8.87865 2.87525 -2609 4 44.6429 18.9609 16.3882 -19.7965 -22.2098 30.8606 -2610 6 17.4975 8.71947 40.5884 -15.3884 33.6574 -8.04213 -2611 4 18.1832 9.38307 40.741 -0.0730079 1.31818 -0.306908 -2612 4 17.9142 7.90906 40.8182 15.4372 -26.466 6.58932 -2613 6 30.1853 27.2566 27.195 -12.9952 17.3445 1.1523 -2614 4 31.1231 27.467 27.0889 -0.851996 0.391463 0.93648 -2615 4 29.6983 28.1205 27.2412 18.1484 -22.709 -4.59112 -2616 6 43.0643 26.2027 28.3545 -5.31946 22.0639 -20.7107 -2617 4 43.281 25.753 27.5201 1.76973 -3.45008 6.18356 -2618 4 43.0898 25.5645 29.0616 2.35339 -12.574 6.70826 -2619 6 27.9963 7.58777 3.05558 10.5798 9.34284 19.8534 -2620 4 28.0446 6.83168 2.47717 -2.58104 -14.3156 -10.0889 -2621 4 28.509 7.35692 3.86128 -6.64638 2.01122 -8.68086 -2622 6 44.6822 7.22369 10.1895 -15.4824 21.4485 13.7445 -2623 4 44.4465 7.45383 11.1264 7.27839 -9.51736 -18.1425 -2624 4 45.2115 6.42757 10.2073 4.94307 -7.89984 8.76143 -2625 6 23.5336 20.3897 32.2571 -4.86538 -1.36788 -16.1605 -2626 4 23.3032 21.2113 32.7104 1.28111 0.523216 5.34569 -2627 4 23.9774 19.8232 32.8948 2.81274 0.218846 6.19737 -2628 6 37.5478 21.0473 29.278 -18.5062 7.79735 6.57819 -2629 4 37.2371 20.358 28.6908 4.72073 -14.165 -12.1471 -2630 4 36.7158 21.4163 29.628 13.2175 4.90017 2.66375 -2631 6 49.286 29.0703 28.699 10.8186 8.22027 -9.31733 -2632 4 48.7028 29.7991 28.456 -10.3299 -0.414367 -0.610456 -2633 4 50.1517 29.4276 28.433 0.637469 -9.81751 4.99071 -2634 6 47.52 18.1671 15.2208 -2.7229 30.7912 -34.1138 -2635 4 48.0078 17.7317 15.8928 12.2019 -13.0526 25.5862 -2636 4 48.0044 19.0008 15.0204 -10.6208 -16.322 3.06818 -2637 6 23.2448 11.1727 16.5931 -14.8157 -11.6244 -0.308602 -2638 4 23.8342 11.8286 16.2582 11.4387 21.3683 -6.30591 -2639 4 23.6559 10.3501 16.3116 -3.14365 -5.23997 2.15847 -2640 6 3.13911 8.33446 23.1963 -2.69702 8.14317 3.16076 -2641 4 3.4034 7.82956 22.4196 3.11719 -1.75335 -2.44085 -2642 4 3.61355 9.18537 23.1574 -2.855 -3.87959 1.25156 -2643 6 0.502965 16.1866 6.18545 3.06312 3.24934 37.7622 -2644 4 1.47856 16.2897 6.04903 -24.0003 -4.70784 4.68468 -2645 4 0.309706 16.1237 7.18858 13.4295 2.89967 -42.1744 -2646 6 43.1771 15.7066 5.83749 -5.07319 -7.51407 -5.60477 -2647 4 43.0136 16.4204 6.43488 -7.5966 11.2789 14.4199 -2648 4 44.0623 15.8898 5.5251 15.5631 0.134699 -7.60204 -2649 6 16.7019 35.4798 34.4572 -11.2013 7.16284 28.6023 -2650 4 15.9782 34.9492 34.0738 5.35466 1.61493 8.45244 -2651 4 16.3895 35.7941 35.362 6.52255 -9.83405 -29.4813 -2652 6 38.8822 7.74245 15.6771 24.467 26.2162 11.5837 -2653 4 39.1941 7.06316 15.0707 0.325231 -3.95447 -5.25413 -2654 4 39.6937 8.2709 15.9758 -30.2905 -22.5291 -12.0432 -2655 6 42.0043 36.5204 13.6369 3.57579 19.2035 0.0265624 -2656 4 41.9371 35.5667 13.6578 -6.58441 -9.91584 1.38486 -2657 4 41.1548 36.8737 13.3269 0.670997 -7.61264 0.497391 -2658 6 54.2965 15.3698 32.1203 7.94984 -1.57724 11.6593 -2659 4 0.00278476 15.9714 32.4364 -1.97539 -6.90512 -0.0853595 -2660 4 53.6257 15.9484 31.7567 -4.83125 0.736868 -4.95397 -2661 6 22.8953 13.994 39.0277 29.317 0.766946 3.70607 -2662 4 23.2673 14.8115 39.3939 -3.87119 -6.48985 -1.20924 -2663 4 21.9724 14.1463 38.894 -27.0425 2.87882 -4.26486 -2664 6 48.0413 28.5291 4.79053 -11.6037 -2.58599 22.6989 -2665 4 48.6027 28.7991 4.07655 16.555 3.34212 -19.6439 -2666 4 47.7045 29.3636 5.15455 0.064426 -0.719185 3.47056 -2667 6 48.8324 10.6079 2.66689 -4.06073 -3.45613 -38.269 -2668 4 48.225 10.1372 3.21562 -13.339 -11.2438 14.6703 -2669 4 49.3888 11.1314 3.20945 16.7197 17.33 23.918 -2670 6 17.1017 29.3417 4.42129 -6.1746 1.2215 19.6287 -2671 4 16.2515 28.9749 4.73431 4.06151 0.983408 -5.41825 -2672 4 17.5169 29.7258 5.22535 1.37581 -6.66399 -13.2687 -2673 6 27.7925 7.31966 26.5665 39.3465 35.5797 -5.30427 -2674 4 28.7629 7.09708 26.703 -34.5848 -6.71948 -0.628584 -2675 4 27.2286 6.57009 26.6643 -1.86949 -31.2701 4.24572 -2676 6 18.0221 22.0409 22.5172 -16.5701 10.2349 -21.3339 -2677 4 18.5639 21.2383 22.5163 -1.8186 -3.43948 -8.36361 -2678 4 17.5144 22.1102 21.6408 22.068 -10.0871 32.2991 -2679 6 22.1395 25.0891 16.7042 -20.9036 23.9116 7.05274 -2680 4 21.7854 25.6501 15.9625 11.5166 -19.4533 18.3362 -2681 4 22.5191 24.3092 16.3181 5.92374 -8.20656 -11.3677 -2682 6 25.488 28.4523 7.12785 -10.8823 -15.9396 20.8595 -2683 4 25.4981 28.5494 8.12476 3.48758 8.16016 -33.1398 -2684 4 25.5521 29.3092 6.69674 -1.4246 11.8198 7.49476 -2685 6 42.5416 24.7341 23.7389 -17.4504 20.5814 2.46415 -2686 4 41.7374 25.1978 24.1118 21.637 -12.0739 -8.95046 -2687 4 42.3838 23.7928 23.8344 -7.43983 -12.597 1.84916 -2688 6 6.22002 16.6178 2.47863 15.1987 22.5956 5.3052 -2689 4 5.33799 17.0017 2.41879 -13.1624 -14.3434 -0.0608379 -2690 4 6.24934 15.6649 2.55192 -10.5885 -12.312 -0.729605 -2691 6 47.3735 33.281 1.45237 -1.26376 -9.34891 -34.4477 -2692 4 47.004 34.1558 1.53803 -0.151384 8.42018 6.19826 -2693 4 47.7374 33.0316 2.29181 5.29029 2.56444 17.845 -2694 6 1.28124 36.1882 24.8833 15.6174 10.404 -23.7919 -2695 4 0.591937 36.4933 25.4703 -7.67557 -4.15788 11.0948 -2696 4 1.63511 35.375 25.2549 -3.92235 -3.89482 10.8998 -2697 6 20.9296 29.0485 16.4244 -14.8946 8.72798 0.140185 -2698 4 21.4494 28.4837 15.8729 6.14594 -21.5718 -11.6475 -2699 4 21.5122 29.7657 16.643 5.64358 11.2813 6.66084 -2700 6 18.6504 32.5428 14.1464 30.5599 1.70581 -2.73789 -2701 4 17.8579 33.056 14.2705 -20.3424 -4.20043 8.80032 -2702 4 18.5989 31.5954 14.3835 -16.0449 10.8642 1.76069 -2703 6 15.729 41.6925 0.00385817 -5.28292 -15.868 -0.0471225 -2704 4 15.6317 41.084 41.1283 -1.722 11.921 23.9575 -2705 4 15.1873 41.3899 0.782005 8.67232 1.52126 -23.9336 -2706 6 20.5292 18.4098 7.21323 -2.91221 4.89049 5.17577 -2707 4 20.2914 18.5583 8.16487 -5.028 -0.721877 -18.2737 -2708 4 19.7413 18.3526 6.62958 8.30767 0.291632 18.8261 -2709 6 35.3342 2.82915 1.61883 3.51298 26.3767 19.1091 -2710 4 35.0331 3.19583 2.50754 16.3791 -7.36031 -35.2043 -2711 4 35.9206 3.53855 1.22039 -16.4006 -18.5858 14.5973 -2712 6 48.9922 19.6721 24.94 -34.075 0.0390245 -1.22883 -2713 4 49.8199 19.2352 24.7823 16.5976 -0.114011 -0.96393 -2714 4 49.1617 20.6125 25.0649 5.94448 -3.86752 4.03728 -2715 6 26.0294 7.18427 41.5679 18.6543 -22.0446 -14.9111 -2716 4 26.7755 6.56315 41.735 -11.6555 11.6244 -4.08136 -2717 4 25.6575 7.3193 0.515359 -11.3234 5.2253 22.1616 -2718 6 22.0232 3.61039 29.0191 -5.74486 -2.38085 -7.46091 -2719 4 21.2539 3.82496 28.4513 11.98 3.27859 6.66273 -2720 4 22.2148 4.35673 29.5966 -4.60401 3.08527 0.791206 -2721 6 27.8512 32.5337 20.6565 16.709 -10.0789 14.6393 -2722 4 26.9625 32.7469 20.4552 -34.4793 1.21347 -3.16249 -2723 4 28.3469 33.1233 20.1026 12.1012 5.18966 -5.24336 -2724 6 8.41229 24.7869 3.46082 22.3386 15.1563 9.53263 -2725 4 8.90357 24.2552 2.84068 9.55631 -8.44952 -10.853 -2726 4 7.60423 24.3318 3.61908 -22.8615 -12.1417 2.22131 -2727 6 30.5897 41.7312 15.6484 22.6974 7.2585 28.5546 -2728 4 29.9644 0.0840213 16.3484 1.9076 -3.76769 -8.41354 -2729 4 30.1014 41.5664 14.8669 -20.7398 -7.21626 -25.2002 -2730 6 48.088 5.62638 21.1953 6.60529 -8.20232 0.106871 -2731 4 47.6746 6.34733 20.7055 -8.23977 -5.05625 1.96425 -2732 4 47.4017 5.06013 21.5879 -0.150274 10.975 -6.21391 -2733 6 39.4216 23.1741 35.7526 -24.6601 -13.9913 -21.1364 -2734 4 39.9113 23.6202 36.3986 28.8985 24.9348 33.8823 -2735 4 38.8958 22.5444 36.2533 -4.57276 -5.65639 2.90172 -2736 6 51.5794 33.3637 5.78804 -15.2387 -43.0642 -16.4958 -2737 4 51.7543 34.264 5.94613 8.32006 43.2545 8.99501 -2738 4 51.5314 33.243 4.82206 1.27667 3.09716 8.04215 -2739 6 40.1245 17.6149 30.7901 8.56984 -3.86721 -1.09973 -2740 4 39.7659 18.4612 31.0527 -2.58034 0.199434 5.42908 -2741 4 40.7245 17.8709 30.0792 -0.880063 -10.8459 -3.09375 -2742 6 46.409 9.80599 18.5787 -10.6525 10.5445 16.3312 -2743 4 47.1858 10.3579 18.4839 1.73901 1.20814 1.97642 -2744 4 46.4156 9.2339 17.8265 -1.18405 -17.3223 -19.0152 -2745 6 15.8964 41.084 31.9275 -7.67529 -16.3413 6.36199 -2746 4 16.5726 40.6297 31.3851 0.744388 15.1086 2.48527 -2747 4 16.0838 0.121849 31.9545 10.6182 0.477469 -6.79561 -2748 6 48.5579 25.7373 14.9245 -32.9201 0.62376 14.4593 -2749 4 49.4842 25.8337 14.7718 19.5896 2.21134 -17.0603 -2750 4 48.049 25.8802 14.1037 15.4245 2.93063 1.46628 -2751 6 39.2312 28.9787 36.1455 -14.672 -4.00104 3.01304 -2752 4 39.9934 29.3216 36.628 6.25522 6.25199 -7.03146 -2753 4 39.4638 28.7366 35.2366 10.4577 0.0924929 -3.6403 -2754 6 37.3289 21.0516 14.9314 -10.8689 -7.09111 1.49701 -2755 4 38.071 20.892 14.3011 -28.0288 10.0477 -1.14031 -2756 4 36.4673 21.3942 14.5393 36.2132 -8.93414 7.14583 -2757 6 32.4934 22.8531 15.7417 3.10645 -11.4389 20.7178 -2758 4 31.7266 22.539 15.2235 4.17967 -1.79737 6.20971 -2759 4 32.6084 22.2825 16.5528 -7.19864 12.5613 -26.7488 -2760 6 18.5678 8.15053 37.5885 12.1963 17.253 1.38788 -2761 4 19.2402 8.85275 37.7813 -15.6951 -12.294 2.78452 -2762 4 17.9606 8.11124 38.3342 2.60008 5.05619 4.87993 -2763 6 46.9436 30.3797 11.0104 1.88703 -1.83756 -2.66296 -2764 4 46.4577 30.6986 10.2121 16.8565 -15.5671 12.8865 -2765 4 47.4104 29.5424 10.7815 -11.8828 15.01 -3.66074 -2766 6 54.6316 13.0448 30.6676 -4.47091 -6.8042 2.85617 -2767 4 54.8929 12.2323 31.1402 -1.2342 7.60269 0.15722 -2768 4 54.6603 13.771 31.309 -0.297949 0.849652 -1.52079 -2769 6 32.2951 35.1224 27.9786 -1.77947 21.9995 15.3623 -2770 4 32.2792 35.8643 28.662 -2.01418 -27.5067 -15.3374 -2771 4 32.1621 34.2527 28.3767 0.559318 -0.0892981 14.8897 -2772 6 4.45055 25.4036 31.7899 -1.02142 -16.2715 16.4968 -2773 4 4.99753 24.9958 32.4777 -6.33224 -6.47315 3.67169 -2774 4 4.91071 26.2154 31.6821 9.55032 31.2277 -12.9728 -2775 6 40.7771 38.1434 21.8579 6.80518 1.6634 -4.63259 -2776 4 40.7449 39.0581 22.1203 -10.5616 15.8809 15.9679 -2777 4 41.4448 38.2055 21.1733 6.63637 -13.627 -11.1518 -2778 6 26.6799 9.85647 27.3982 -25.6987 30.8747 18.2417 -2779 4 27.0738 9.12687 26.9584 7.64189 -30.2216 -11.3166 -2780 4 25.7862 9.62595 27.7363 13.5029 -2.01996 -6.34848 -2781 6 53.4177 39.431 11.7682 60.4327 6.90374 -14.3662 -2782 4 54.4363 39.4906 11.5459 -51.7213 -2.15349 13.0324 -2783 4 53.0514 40.2823 11.4531 3.65586 -10.6921 6.91198 -2784 6 35.3318 21.4177 2.24537 5.41769 -12.1321 -20.1082 -2785 4 34.8431 20.6225 2.51379 1.47903 7.83344 1.83382 -2786 4 35.7036 21.1864 1.3528 -11.9529 6.47568 24.5243 -2787 6 4.13637 17.136 33.9211 3.37621 -12.3766 5.67686 -2788 4 4.20441 16.396 34.5697 -7.88327 11.3141 -11.775 -2789 4 3.23668 17.1493 33.5445 4.32036 -6.23827 5.33579 -2790 6 24.1551 16.173 14.6595 0.905264 -13.203 -15.7913 -2791 4 24.2344 17.0724 14.9677 3.21898 8.1818 3.14137 -2792 4 23.7074 16.2777 13.8038 1.81958 -4.41422 2.08172 -2793 6 43.135 2.84466 26.1032 13.1229 6.35408 -5.68313 -2794 4 42.2875 3.17639 26.414 -4.49653 4.08553 -4.30298 -2795 4 43.2684 3.17059 25.1875 -5.24638 -3.17663 12.7173 -2796 6 40.6938 12.184 1.56501 -11.5288 -7.07153 -25.6549 -2797 4 41.6237 12.1687 1.8186 -0.151998 5.09311 17.9246 -2798 4 40.0653 12.4844 2.24465 11.7671 0.703669 4.7582 -2799 6 47.3771 8.09383 26.755 61.1653 27.2124 16.0462 -2800 4 46.6352 7.69428 26.3774 -33.8593 -24.2939 -29.8281 -2801 4 48.1554 8.02079 26.1437 -24.5213 -4.41693 14.2109 -2802 6 35.8722 30.7298 38.4929 46.7797 8.20249 -0.795626 -2803 4 35.8437 29.9971 39.0885 -23.8052 -20.0767 8.1402 -2804 4 36.8495 30.8926 38.5637 -31.083 11.8011 -18.5205 -2805 6 51.2951 23.2205 32.4921 -21.4102 17.5258 -2.96787 -2806 4 51.6315 24.0445 32.1105 -0.705735 5.94923 -0.836877 -2807 4 52.0737 22.714 32.6486 16.7198 -16.4886 4.04233 -2808 6 30.6141 4.4461 39.6711 -15.3731 3.79473 -35.0115 -2809 4 30.9464 3.61986 40.0176 9.77962 -4.83986 19.2734 -2810 4 30.7704 5.18568 40.2576 9.11216 5.26318 14.244 -2811 6 35.2646 29.7051 2.85778 -14.8887 -12.395 -20.7058 -2812 4 35.7986 29.7272 2.02588 -11.2321 -1.99949 14.2373 -2813 4 34.4405 29.1492 2.64359 32.9241 21.0754 6.44042 -2814 6 50.3111 26.1454 9.40098 -22.1621 10.9454 -20.0185 -2815 4 49.986 26.7793 8.71172 15.2241 -16.6208 13.1315 -2816 4 49.7063 25.388 9.31525 11.793 4.08785 3.97386 -2817 6 50.0869 36.8245 26.4088 -20.9012 -6.38176 7.71076 -2818 4 49.5586 36.0705 26.7514 3.9746 5.79943 -8.74909 -2819 4 50.1941 37.3864 27.1871 4.41306 8.36789 0.548966 -2820 6 40.3119 23.9565 38.5384 47.4279 -1.39254 -15.5521 -2821 4 40.88 24.732 38.748 -21.3925 -13.0784 -2.40019 -2822 4 39.4343 24.1145 38.8527 -20.1214 13.5622 11.7594 -2823 6 24.9444 10.7496 30.6663 31.051 18.5451 27.0394 -2824 4 25.7305 10.8456 31.2787 -28.4 -7.1047 -26.2292 -2825 4 24.8995 11.6269 30.2371 -7.15612 -14.1049 -2.61146 -2826 6 5.89131 1.01728 5.39947 -5.16247 -17.9253 -0.227043 -2827 4 5.22088 0.340863 5.59281 2.49468 7.88844 1.50452 -2828 4 6.71299 0.544267 5.57411 4.99832 4.76302 -4.28882 -2829 6 44.2927 29.3807 26.2764 43.728 -18.4205 -0.18667 -2830 4 43.5018 29.5461 25.816 -39.4067 7.83222 -12.62 -2831 4 44.7851 28.7616 25.699 -3.50466 6.32584 16.51 -2832 6 25.3064 10.1814 6.6654 -6.94402 -15.718 -9.61204 -2833 4 25.6542 11.0594 6.61048 6.10034 18.8978 1.37462 -2834 4 25.5624 9.77067 5.8255 0.943829 -2.29537 1.40094 -2835 6 13.3606 28.0664 2.58456 21.0736 -2.27515 1.79417 -2836 4 12.4645 27.8304 2.42125 -25.9451 -0.745297 2.44011 -2837 4 13.7867 27.7237 1.79619 10.8353 3.06046 3.23802 -2838 6 6.45257 40.24 18.0133 20.0379 8.33657 1.98834 -2839 4 6.89988 39.3931 17.8777 -5.14522 -3.62214 0.392952 -2840 4 5.56311 40.1207 17.6969 -15.0406 -3.82351 -6.06839 -2841 6 47.8011 13.5056 2.01844 -10.5648 -21.267 23.3214 -2842 4 48.1524 12.6081 2.17165 -2.87721 6.43796 -2.24674 -2843 4 48.4275 13.9546 1.48105 20.9852 11.6376 -18.273 -2844 6 13.5939 20.3067 2.43603 17.8956 14.689 14.157 -2845 4 13.8339 19.6256 3.09172 -4.40777 3.66463 -6.9739 -2846 4 12.9598 19.9059 1.86118 -14.8369 -10.3601 -11.305 -2847 6 15.2334 0.8368 36.6591 1.55142 7.70692 -22.3998 -2848 4 15.2542 1.38367 37.4773 0.960764 -3.32816 -20.1037 -2849 4 15.3344 1.45306 35.8608 -4.23652 -17.7771 37.8382 -2850 6 33.6147 35.2459 15.1 16.7734 -11.8793 -18.4599 -2851 4 33.8163 35.2873 16.0538 13.2499 -3.34836 -12.9991 -2852 4 34.4154 34.9808 14.5294 -23.6504 9.8312 34.8639 -2853 6 21.8005 9.23588 0.431159 13.8262 -19.7524 30.0596 -2854 4 22.4067 9.05801 41.6249 5.27322 -0.932182 -12.5411 -2855 4 21.1072 9.74412 0.0564903 -22.836 18.1195 -16.0408 -2856 6 38.1565 27.4627 3.04439 18.4183 -28.2807 7.84104 -2857 4 37.7322 27.3164 2.21113 -4.60599 -14.2952 -24.3043 -2858 4 37.7632 28.2451 3.34335 -13.6136 36.2365 19.5187 -2859 6 38.8873 27.196 11.7739 15.5044 -8.33717 -5.93911 -2860 4 38.7841 26.3327 12.232 6.37868 6.61944 -11.5261 -2861 4 39.5786 27.1133 11.0659 -17.5863 -8.28826 19.2684 -2862 6 29.8757 41.5959 28.7066 13.5858 28.49 -11.3766 -2863 4 28.9647 41.3014 28.7466 -9.40406 -2.02578 1.88502 -2864 4 29.8997 0.254331 27.9025 -2.68961 -11.7418 13.302 -2865 6 34.0266 8.72323 38.0698 33.719 9.40995 4.6971 -2866 4 34.8877 8.24089 38.094 -11.378 13.1352 -1.62724 -2867 4 33.3712 8.08689 37.8245 -20.4874 -15.945 -8.86187 -2868 6 38.8142 27.3472 30.6886 -7.48306 -22.0573 -0.58069 -2869 4 38.4096 26.5151 30.3537 9.19692 16.3236 1.53567 -2870 4 38.2655 27.5885 31.4334 -4.0026 6.56393 5.14207 -2871 6 41.6513 17.2644 36.3568 8.49285 18.5772 4.12306 -2872 4 41.236 17.1887 35.5016 -7.55839 -3.54967 -10.3568 -2873 4 41.7813 16.3888 36.7033 1.22956 -17.0266 1.65102 -2874 6 30.7157 26.9788 35.2038 -10.151 -4.28381 0.0670681 -2875 4 31.4488 27.4236 34.7965 20.0965 0.384289 -13.2747 -2876 4 30.343 27.6484 35.7639 -8.80839 6.96039 12.3672 -2877 6 47.5342 4.10778 27.2888 11.6095 8.93875 26.3727 -2878 4 46.6105 4.27591 27.501 -8.38331 -0.425724 -4.8003 -2879 4 47.5988 3.99389 26.3497 -6.2541 -0.220522 -17.1995 -2880 6 20.9412 8.38521 7.26575 -18.1268 -17.2637 2.68033 -2881 4 20.8809 8.87169 8.08328 -6.592 1.96128 21.9757 -2882 4 21.4179 8.98778 6.73029 19.5174 18.1449 -30.7672 -2883 6 36.8608 13.6781 0.872276 -22.567 18.0135 -7.8322 -2884 4 37.3857 13.5342 1.64823 18.2236 -14.2068 17.6988 -2885 4 36.9649 12.9376 0.269125 7.56106 -9.0363 2.17502 -2886 6 28.5805 20.3012 26.4498 13.4935 0.222411 -13.7489 -2887 4 28.4835 19.3803 26.2016 0.90122 -3.21423 2.30104 -2888 4 27.7964 20.5416 26.9224 -18.5183 5.12398 12.3317 -2889 6 51.6021 16.8515 33.5179 -11.2544 -15.3 0.627003 -2890 4 51.563 16.0241 34.0301 0.916298 4.09207 -0.753195 -2891 4 51.0058 16.6639 32.7753 6.31462 4.20327 -0.345536 -2892 6 16.2626 32.019 37.6812 -31.2107 -29.2496 -22.9287 -2893 4 16.4537 31.3803 38.4011 -2.23747 12.829 -12.3594 -2894 4 15.5373 31.5705 37.1079 31.9743 21.1891 23.5065 -2895 6 14.3366 25.8859 13.2055 -16.2598 35.1345 -7.65407 -2896 4 13.5591 26.1022 13.7538 4.79106 -9.45955 4.66587 -2897 4 14.3924 26.7004 12.6499 8.67511 -16.0651 4.90492 -2898 6 54.9632 28.863 3.30225 1.80665 -46.0259 4.02989 -2899 4 54.8334 28.8705 2.33571 2.30679 -1.29159 7.0988 -2900 4 0.250446 27.9134 3.53944 -11.9885 37.0888 -10.0107 -2901 6 17.2065 5.13222 2.58226 -24.5489 -19.7693 -14.9516 -2902 4 17.8239 4.45011 2.8785 5.4716 1.45995 5.40018 -2903 4 17.4096 5.93537 3.0482 10.2082 3.99522 6.08435 -2904 6 50.7076 33.0524 10.3335 3.48719 10.0002 9.95533 -2905 4 50.6136 33.804 9.75033 0.0726689 14.8217 2.89741 -2906 4 50.6632 32.3255 9.72979 -1.7797 -23.5385 -6.20373 -2907 6 28.8719 19.8379 32.3662 12.2168 9.43689 -9.94144 -2908 4 29.8293 20.0527 32.223 -26.7315 -2.75674 4.09206 -2909 4 28.3919 20.677 32.2058 6.96369 -8.55206 2.54368 -2910 6 22.4258 12.8301 23.3099 -21.9068 12.8519 23.6974 -2911 4 22.5424 12.4187 24.2055 -3.2327 9.70973 -17.8182 -2912 4 21.6904 13.4906 23.4219 18.0295 -16.5223 -3.23075 -2913 6 54.7859 15.5473 8.87871 3.42684 8.57095 -7.37477 -2914 4 0.5152 15.244 9.45304 -3.41058 -4.28924 6.32649 -2915 4 53.9742 15.1056 9.16818 6.16615 -2.4265 3.01646 -2916 6 10.455 19.2982 26.169 33.281 -8.93788 40.2277 -2917 4 11.227 18.6906 26.1605 -15.5014 12.2348 -4.03004 -2918 4 10.0694 19.2521 25.3251 -19.4777 -1.76614 -41.28 -2919 6 38.6541 20.3016 35.2246 25.1317 -2.89776 0.584273 -2920 4 39.6122 20.389 35.0245 -16.8563 1.20482 1.7302 -2921 4 38.6037 19.6498 35.9401 -3.42784 5.37932 -3.92632 -2922 6 17.4847 18.0451 15.2473 -2.11698 43.6037 15.5575 -2923 4 17.3165 17.6253 14.4157 -4.81229 -12.7227 -25.2707 -2924 4 17.3243 19.0143 15.0283 6.45297 -29.0578 8.37137 -2925 6 29.6412 0.96029 26.2538 -2.92598 -32.1867 -14.968 -2926 4 29.2295 1.80722 25.9783 -5.05853 -19.2177 -5.0061 -2927 4 29.2302 0.136786 25.7855 11.2507 47.838 14.1271 -2928 6 30.4583 12.6781 28.2933 9.80318 -11.3268 12.128 -2929 4 29.9046 13.1756 27.6811 -9.35495 -4.05719 -6.55314 -2930 4 30.1425 11.7563 28.3949 -4.92949 12.905 -7.65094 -2931 6 36.6582 22.1039 33.3564 18.5548 3.44171 -30.7077 -2932 4 37.613 21.8793 33.4826 -21.695 5.78572 4.26475 -2933 4 36.1698 21.8632 34.1249 -2.38139 -6.6943 29.4942 -2934 6 34.851 22.4634 14.295 34.3706 -12.4795 -36.6647 -2935 4 34.1306 22.5878 14.8998 -26.9044 -0.864951 1.69223 -2936 4 34.6097 22.0485 13.4154 -10.7342 10.9778 31.0087 -2937 6 15.5278 9.60588 7.43972 42.9889 -30.8008 -13.2318 -2938 4 16.5289 9.52064 7.17624 -51.4641 3.68278 11.9177 -2939 4 15.1523 8.68078 7.51431 10.3517 24.0811 1.24627 -2940 6 21.8097 28.0449 19.8036 -9.3837 2.2861 -3.69714 -2941 4 21.8234 28.4749 20.6579 1.49564 5.45585 8.79124 -2942 4 20.892 27.7474 19.715 3.3935 -2.50466 0.747966 -2943 6 34.5377 24.4067 2.43307 17.6783 -35.0943 7.08511 -2944 4 34.5604 23.3833 2.29911 9.6022 45.0517 12.0591 -2945 4 35.2671 24.6922 3.07368 -22.5652 -15.0324 -19.8681 -2946 6 12.5974 20.9324 33.5156 -46.2472 -18.3539 -4.34371 -2947 4 11.7028 20.621 33.8238 24.9199 8.0821 6.3307 -2948 4 12.4411 20.8933 32.5604 17.1824 5.4367 5.76912 -2949 6 45.7726 31.1546 8.70236 -14.9606 25.5026 -0.599968 -2950 4 45.9029 32.1319 8.75243 4.68257 -18.3747 -3.63409 -2951 4 44.8252 31.0158 8.86685 6.58294 -2.27884 -1.49072 -2952 6 15.4856 22.546 30.183 -27.3843 -7.95278 -8.87715 -2953 4 16.2041 23.1276 30.4314 15.0704 -4.03687 4.09321 -2954 4 15.7065 21.6006 30.174 10.2057 11.8959 3.83923 -2955 6 39.7496 17.1848 38.4183 10.7213 7.86871 6.49434 -2956 4 39.4778 16.5926 37.6964 5.17631 5.73732 3.80123 -2957 4 40.5328 17.6892 38.1152 -12.3514 -12.5856 -1.70264 -2958 6 14.0114 24.6894 0.67727 2.36324 3.45559 -2.63023 -2959 4 14.2236 24.5974 1.61702 0.728832 5.12592 -0.706901 -2960 4 14.3876 25.5307 0.374588 3.08684 -2.75846 6.71077 -2961 6 31.517 19.5744 3.57234 -39.7066 16.7987 -9.47084 -2962 4 30.9812 19.3042 4.35775 22.6375 1.42354 -10.5596 -2963 4 32.4299 19.3292 3.64982 19.3858 -12.3464 7.87151 -2964 6 36.0836 25.0594 19.4567 -36.7914 6.39304 28.0525 -2965 4 37.0156 25.1955 19.4145 23.7106 3.97855 -3.98164 -2966 4 35.8434 24.7134 18.6052 0.797557 -6.28507 -17.3783 -2967 6 51.6689 17.6827 14.8094 17.1445 12.5774 26.8045 -2968 4 51.9037 18.5572 15.2299 -9.72171 -22.1194 -12.5657 -2969 4 51.1779 17.9239 14.0295 -8.26923 9.08158 -15.405 -2970 6 37.7112 27.5006 38.1887 12.9616 35.4771 9.449 -2971 4 37.6633 26.7956 37.5532 1.11487 -12.4995 -15.1422 -2972 4 38.1924 28.2458 37.7567 -11.1334 -22.4905 3.32353 -2973 6 34.7974 13.8528 30.7792 38.2139 14.8122 -13.8353 -2974 4 35.0479 14.6237 31.2931 10.1718 6.91547 -1.09557 -2975 4 34.0108 13.6012 31.1887 -47.9834 -23.6229 17.9792 -2976 6 19.6227 37.378 39.9679 -4.73731 -6.94245 -18.3615 -2977 4 20.5687 37.4692 40.1123 7.88808 5.09103 7.87528 -2978 4 19.5641 36.8976 39.1176 -6.21843 3.50671 7.67834 -2979 6 40.9479 34.0678 21.4433 -0.249567 -14.1225 -18.8789 -2980 4 41.1016 33.9428 22.3797 -2.14769 -1.67588 5.36328 -2981 4 40.6839 33.1793 21.1286 -1.36491 12.9737 -0.808456 -2982 6 32.9563 27.2052 26.5619 16.765 25.3633 38.6423 -2983 4 33.6584 27.782 27.0193 -28.2502 -21.1678 -18.3317 -2984 4 33.3196 26.985 25.7164 10.2198 -2.00428 -21.725 -2985 6 24.4119 18.6722 15.6191 2.60565 2.56356 0.790403 -2986 4 23.5591 19.1036 15.7005 -5.06369 4.62453 -0.705819 -2987 4 24.5532 18.2558 16.4735 3.02917 -4.75652 8.16225 -2988 6 29.9677 1.63803 9.07283 -8.6377 39.5876 -9.34009 -2989 4 30.0634 0.720354 9.20948 2.18912 -36.9171 5.61628 -2990 4 29.1461 1.70687 8.54641 9.48634 -0.985828 6.78106 -2991 6 31.4838 20.0989 7.86304 35.53 0.0326438 -30.7549 -2992 4 32.0429 19.6076 7.17649 -26.3889 9.76992 30.1887 -2993 4 30.8408 19.4752 8.19414 -7.49558 -12.7978 -1.24617 -2994 6 35.0504 3.77818 33.2765 0.0823497 -0.922868 12.9261 -2995 4 34.3448 4.25588 32.7981 8.7563 -3.59111 2.91721 -2996 4 34.8655 3.9194 34.2319 -2.64551 -3.11561 -17.2257 -2997 6 43.9652 7.96842 12.9746 -1.99776 -12.8019 0.966431 -2998 4 43.3695 7.30717 13.3748 13.3395 3.08022 -2.86187 -2999 4 43.3917 8.71398 12.8108 -3.39849 12.2944 -1.42541 -3000 6 44.1076 32.6848 16.9531 4.83347 14.0385 -4.8226 -3001 4 44.7886 33.3699 16.7553 -9.08835 -13.3706 7.91806 -3002 4 44.1269 32.547 17.9059 1.63547 3.97279 4.50154 -3003 6 40.604 27.1617 19.037 5.49217 0.683783 -24.0967 -3004 4 39.907 26.5243 18.7614 10.7357 10.4426 0.818988 -3005 4 41.0572 27.5561 18.2306 -16.7517 -14.1941 23.9583 -3006 6 46.0503 23.2068 29.0603 33.2935 27.7725 23.492 -3007 4 46.7239 23.8517 29.4252 -26.0483 -15.0892 -12.6312 -3008 4 46.5249 22.3737 28.9794 -1.25341 -9.22801 -2.13192 -3009 6 42.6264 30.606 18.8462 -34.271 -0.881878 -8.8004 -3010 4 43.5242 30.7893 19.1074 18.3218 -5.88078 -5.57768 -3011 4 42.5428 29.9264 18.1492 10.4183 2.57162 5.03187 -3012 6 36.1231 10.8975 23.2614 14.248 33.6052 6.96597 -3013 4 35.2264 11.248 23.1278 1.11349 -2.62395 -2.03304 -3014 4 36.6438 11.7125 23.5215 -18.5882 -27.5405 -10.5609 -3015 6 13.7387 31.5187 15.7175 -8.63655 -3.85126 -4.64142 -3016 4 14.6788 31.7096 15.8046 0.813603 4.25462 -2.48371 -3017 4 13.3439 32.0503 15.0041 7.14664 -1.81478 4.34843 -3018 6 33.1663 41.4263 27.7844 10.1514 -8.73892 50.1834 -3019 4 33.0558 0.0915148 27.0508 0.335607 20.6114 -25.4934 -3020 4 33.386 0.0476391 28.6 -4.59167 -12.6797 -24.4066 -3021 6 32.8924 22.9248 31.4777 14.8331 -14.2772 -3.0724 -3022 4 32.331 22.9976 30.6823 -4.11553 14.0534 8.76104 -3023 4 32.7731 23.648 32.1168 -12.639 5.72297 -14.9522 -3024 6 27.6514 16.8629 6.392 5.9792 -3.02818 28.7598 -3025 4 27.8554 17.3015 5.57876 -0.492343 9.99532 -20.1105 -3026 4 26.7867 16.4634 6.29535 -11.4685 -3.6273 -5.68351 -3027 6 47.2692 11.6326 26.0701 -7.51592 -12.561 -4.95541 -3028 4 47.0451 11.5188 27.0189 12.1951 16.3083 -15.426 -3029 4 47.7234 12.4489 25.7723 -5.45211 -2.19527 19.0308 -3030 6 27.5533 7.05227 7.64253 19.1893 -9.34804 28.5196 -3031 4 26.7486 7.45205 7.94122 -22.9318 8.15137 -1.85106 -3032 4 28.0959 7.04706 8.46187 -1.51515 -0.839126 -23.0353 -3033 6 39.7861 9.0687 11.9758 -15.1444 6.22431 -7.98147 -3034 4 39.495 9.25597 11.0599 4.77492 -2.72739 13.3066 -3035 4 38.9879 9.23938 12.5098 3.46881 -0.389139 -2.20355 -3036 6 18.1894 33.4728 36.1008 -27.5283 -9.1571 7.06889 -3037 4 17.6722 33.9726 35.425 4.94426 -9.47891 13.9641 -3038 4 17.5468 32.9442 36.6812 19.6546 19.0371 -24.2711 -3039 6 37.1945 26.5569 0.720807 -12.4444 8.19753 -2.53971 -3040 4 37.3568 25.6462 0.476597 4.7119 -6.04631 0.679389 -3041 4 36.2336 26.6328 0.585525 8.76389 3.8419 -0.879611 -3042 6 44.2004 19.6233 36.8917 26.7932 -13.3754 0.0595121 -3043 4 45.0387 19.0956 36.766 -19.227 18.7818 5.02367 -3044 4 44.4376 20.5683 36.9644 1.27086 -9.01627 -1.91077 -3045 6 27.7799 6.35317 35.6882 16.2858 -3.70231 1.18314 -3046 4 27.1634 6.96571 35.2926 -9.46908 3.45363 -4.90602 -3047 4 27.3042 5.53742 35.858 -2.00694 0.00942349 2.38052 -3048 6 34.7653 16.4924 20.8795 20.4023 -19.0949 10.3746 -3049 4 35.5516 15.8729 20.9898 -30.5098 25.2475 -4.70775 -3050 4 34.1298 16.2162 21.5757 7.90375 5.70636 -13.0995 -3051 6 39.0303 20.9673 40.4307 -20.4786 -67.2325 12.8224 -3052 4 38.8254 20.089 40.9106 11.5443 40.6977 -30.184 -3053 4 39.2642 21.5386 41.1412 8.11615 27.562 18.514 -3054 6 10.8068 27.9205 1.65866 27.4379 7.91142 -24.506 -3055 4 10.0967 27.7204 2.22826 -30.9372 -12.069 25.0324 -3056 4 10.8782 28.8813 1.73209 2.10338 1.16742 -2.23752 -3057 6 47.025 23.1272 13.2603 -26.8307 -11.5375 0.419605 -3058 4 47.6563 23.6094 12.7175 1.22463 1.60122 -3.88323 -3059 4 46.2701 22.846 12.6737 25.4538 5.98786 18.4886 -3060 6 34.5769 28.3999 10.6617 -26.3731 9.09486 -11.6064 -3061 4 34.5145 27.7223 11.3448 13.7244 -2.44185 1.37306 -3062 4 35.5023 28.5375 10.4336 6.33869 -4.76798 1.2135 -3063 6 3.33738 17.579 14.2816 -4.12164 13.1786 -2.02309 -3064 4 3.51487 16.7052 14.5979 -0.480238 -24.8864 6.17379 -3065 4 3.96197 18.0965 14.8055 -3.35437 6.17503 -1.46632 -3066 6 27.7248 11.5976 7.52038 4.0705 34.1711 4.34085 -3067 4 27.7194 12.5939 7.6487 2.26317 -33.1326 -4.66749 -3068 4 27.2616 11.2314 8.28138 -1.22149 -2.70865 2.4378 -3069 6 41.4317 28.339 9.02961 12.1835 18.6619 -21.5911 -3070 4 40.932 28.9387 9.57928 -8.65956 3.59764 13.3257 -3071 4 41.6711 28.9179 8.26221 -0.754142 -18.9314 12.3863 -3072 6 42.0732 4.78493 8.18399 0.592074 10.501 -23.0953 -3073 4 42.2656 5.73441 7.90258 -4.03181 -32.5079 3.94615 -3074 4 41.9391 4.19656 7.39311 5.50228 24.8072 19.85 -3075 6 28.4553 8.6408 40.3288 -1.1592 2.81238 -0.593175 -3076 4 27.8014 8.47839 41.05 3.29603 2.13238 -25.5829 -3077 4 28.0374 8.68456 39.4248 -2.58083 -3.24862 30.0681 -3078 6 0.723272 18.248 15.2854 4.61761 3.31073 11.0333 -3079 4 1.58056 18.1517 14.8782 17.0637 -0.561901 -5.4503 -3080 4 0.169553 17.7112 14.727 -13.9143 -7.94922 -7.42873 -3081 6 7.11829 16.2161 40.455 0.573222 -5.60735 -16.9123 -3082 4 7.21814 15.2583 40.7035 1.10072 25.2259 14.7352 -3083 4 7.17549 16.8833 41.1741 1.82325 -21.1089 2.38217 -3084 6 41.0856 8.6232 20.9154 1.44565 10.3804 -0.748136 -3085 4 40.3857 8.53297 20.2693 -12.0873 -13.8416 -3.91841 -3086 4 41.3541 9.53003 20.731 8.87844 6.62655 8.68036 -3087 6 31.7065 7.41805 37.5384 1.8504 0.880847 10.656 -3088 4 31.4927 7.12037 36.644 -5.569 -4.06437 0.235955 -3089 4 30.9766 7.14703 38.1182 6.88034 1.43502 -8.9471 -3090 6 40.7175 11.6353 25.4105 -5.83472 20.1078 -6.29096 -3091 4 40.8441 12.5768 25.6218 -9.59803 -8.51017 -7.38463 -3092 4 41.5254 11.2592 25.7328 13.3582 -17.7026 5.353 -3093 6 29.8893 30.1615 6.66958 6.45784 -4.04896 -4.41327 -3094 4 30.5285 30.6751 6.15191 0.92206 -5.81994 -1.29615 -3095 4 30.2313 29.249 6.64761 -0.535397 8.70224 -1.24193 -3096 6 40.83 24.591 5.67679 17.1105 23.9162 -4.99229 -3097 4 41.4401 25.3556 5.89599 -18.0089 -21.1831 -4.73113 -3098 4 40.1352 24.5742 6.32932 -4.29697 2.2625 8.62223 -3099 6 34.3954 9.09122 20.4203 -0.702674 2.95809 7.47625 -3100 4 33.5897 9.50113 20.7506 -0.63314 5.38769 7.97821 -3101 4 34.107 8.76785 19.5728 -0.194313 -9.82044 -16.4611 -3102 6 18.2164 33.5433 26.5438 32.3972 -29.6611 -30.5808 -3103 4 19.1929 33.4142 26.4527 -23.3283 -2.37285 -6.48837 -3104 4 18.1915 34.0681 27.3044 -13.0981 29.1765 42.7321 -3105 6 28.9207 17.4075 26.7926 -1.66434 -4.11711 9.90999 -3106 4 28.2497 17.0259 26.21 0.151798 0.605301 -3.15085 -3107 4 28.4243 17.7127 27.5796 8.50802 -3.38176 -8.48604 -3108 6 50.4389 35.5612 18.195 -0.220837 -24.3132 -9.08897 -3109 4 50.4331 35.2145 17.2813 -0.853004 14.3463 8.17747 -3110 4 50.3692 34.7248 18.6968 -4.07606 17.1918 3.62275 -3111 6 2.99582 21.5586 31.4575 0.708202 -18.646 -28.6731 -3112 4 3.24926 22.2892 30.8424 -5.67023 -11.8068 12.1364 -3113 4 2.8516 20.7624 30.8616 4.12476 24.3831 20.6408 -3114 6 36.1857 18.7483 8.60511 9.96184 26.1081 -2.68835 -3115 4 36.1356 17.8778 8.93402 3.95956 -36.7917 21.724 -3116 4 35.6171 18.7388 7.85438 -14.2398 9.24248 -24.4438 -3117 6 20.2742 6.47995 33.7286 -0.427153 4.78104 -4.08195 -3118 4 19.8935 6.35632 34.6244 -2.14212 -11.6635 -12.611 -3119 4 20.0876 5.70362 33.1559 -1.45185 1.76636 16.8362 -3120 6 13.9952 30.5211 6.65468 -0.834568 0.374695 7.89925 -3121 4 14.6781 31.0539 7.1149 -10.4447 -7.07426 -7.17019 -3122 4 13.1432 30.7212 7.07951 7.79461 1.02333 -2.73826 -3123 6 36.2732 16.4484 35.7639 18.345 14.0335 0.961522 -3124 4 37.2268 16.2475 35.9495 -24.6333 8.21497 -3.5549 -3125 4 36.1837 17.4253 35.5797 7.74798 -29.1845 4.36862 -3126 6 45.8208 37.6575 9.69399 14.3507 -31.8621 -27.6249 -3127 4 45.4608 38.3019 10.268 -8.06385 16.394 26.7739 -3128 4 46.3975 37.0305 10.1733 -1.81999 10.6315 0.898341 -3129 6 47.4165 17.984 27.6369 4.10759 -46.3966 -5.45297 -3130 4 47.5682 17.4629 26.7823 -7.01073 17.4072 30.8444 -3131 4 47.4562 17.3293 28.4007 0.542452 20.9274 -25.5144 -3132 6 25.9608 18.2932 0.952258 -4.39486 21.5955 18.9376 -3133 4 26.1989 18.9101 1.66086 12.5057 -8.35286 -7.15646 -3134 4 25.0082 18.3237 1.04468 -12.1408 -13.2893 -13.6751 -3135 6 27.3648 22.4066 4.28268 2.26175 -24.9034 0.419816 -3136 4 27.3706 23.3409 4.46802 1.80952 16.8807 -5.51915 -3137 4 27.3027 22.2785 3.32806 -2.77408 5.10873 4.5687 -3138 6 3.39125 3.84856 27.607 3.69966 -10.1033 0.490887 -3139 4 4.0137 4.55908 27.5406 6.78149 24.6072 0.911673 -3140 4 3.97847 3.09168 27.5281 -8.4044 -12.3732 0.103181 -3141 6 45.3633 27.6554 28.8452 2.12727 -1.25659 10.7713 -3142 4 44.5282 27.2015 28.6866 -4.83999 -4.58212 3.48715 -3143 4 45.3811 28.2979 28.14 4.63148 6.41932 -6.37453 -3144 6 28.4005 32.3772 16.2203 23.7034 -3.75626 0.763822 -3145 4 29.2297 32.2225 15.6968 -18.0553 4.16843 14.9752 -3146 4 28.6795 32.6874 17.1033 -0.325788 -1.29005 -11.6373 -3147 6 9.90477 33.835 13.0292 3.70295 -3.7397 30.9684 -3148 4 9.58558 33.3049 13.7992 6.56164 12.5415 -12.6178 -3149 4 9.32425 33.6546 12.2978 -12.2649 -3.83445 -16.8068 -3150 6 38.3301 26.6316 14.917 8.16845 -9.374 -1.40965 -3151 4 38.7482 25.7736 15.154 -10.3234 14.7528 -2.05039 -3152 4 37.3847 26.6122 15.1206 3.66029 -5.29 2.35016 -3153 6 31.3553 16.3729 4.24558 -11.5598 -13.3523 13.2112 -3154 4 30.5395 15.8971 4.54084 13.4071 7.11555 -7.19651 -3155 4 31.205 16.607 3.32285 -2.62497 2.93757 -4.30077 -3156 6 6.17611 3.41063 6.5613 17.7272 3.64487 37.5473 -3157 4 6.46982 3.08663 7.46094 -9.0795 17.2981 -27.883 -3158 4 6.02642 2.6045 6.08389 -2.81663 -13.5692 -12.3872 -3159 6 42.5919 12.9938 5.62253 0.302259 -11.3067 -0.460125 -3160 4 42.3001 13.8766 5.84478 4.87778 6.39543 1.2284 -3161 4 43.5084 12.9049 5.92305 -2.35353 0.46184 -1.33783 -3162 6 41.0467 31.3953 33.7949 3.79599 37.3117 5.16998 -3163 4 40.7289 31.3961 34.7173 5.05156 -5.30154 -15.2916 -3164 4 41.2174 32.3636 33.5809 -4.47671 -37.1445 4.47908 -3165 6 52.8595 12.0576 26.2617 4.7779 -12.5882 -49.4794 -3166 4 52.3971 12.713 26.7564 -13.8804 18.303 15.9364 -3167 4 52.6839 12.2865 25.2977 8.87889 -9.64762 29.5111 -3168 6 39.2197 4.29237 29.0569 11.235 6.95972 3.08537 -3169 4 38.4782 4.84799 29.3396 4.36118 -6.50894 -4.0878 -3170 4 39.9967 4.59393 29.5615 -4.77927 -7.36273 -4.89832 -3171 6 3.64414 27.0065 11.2815 -12.9441 10.9516 -6.43872 -3172 4 4.59106 26.8908 11.2849 14.3058 -9.72403 4.26042 -3173 4 3.53535 27.8319 10.7781 -8.82957 -2.80904 -0.131447 -3174 6 41.5421 29.6442 25.2671 -5.6293 3.19366 2.66863 -3175 4 41.8684 29.6903 24.3723 12.1179 -3.11764 -10.4285 -3176 4 40.7194 30.1326 25.2057 -6.30215 2.63585 1.74894 -3177 6 50.468 27.487 30.6705 -3.05594 -10.4468 2.57161 -3178 4 50.076 27.1594 31.5009 0.806547 4.01213 -5.24181 -3179 4 49.8217 28.0451 30.2184 -2.62753 1.96724 1.87939 -3180 6 32.7902 33.6258 41.7496 -4.87138 -4.97834 -25.0012 -3181 4 33.1641 32.7497 41.8541 3.47816 -11.5824 1.65798 -3182 4 32.8969 34.0586 0.665858 3.16614 12.7166 21.4132 -3183 6 5.9796 9.64598 7.93234 5.57207 13.1841 -10.7861 -3184 4 5.80592 9.95912 8.82583 -0.986272 -0.521215 4.5825 -3185 4 6.43021 10.3852 7.47125 -1.05258 -10.6241 3.31462 -3186 6 52.774 25.3768 27.6816 12.7732 -3.18466 28.0173 -3187 4 52.93 26.2779 28.0237 -8.60677 -10.695 -13.1321 -3188 4 53.2011 24.8527 28.4031 -8.37753 -2.27765 -26.5487 -3189 6 18.6947 23.2095 14.4724 -28.0966 8.43578 15.8218 -3190 4 18.5587 24.1605 14.7523 20.6562 -24.296 -13.1918 -3191 4 19.5669 23.0215 14.1303 11.4888 10.4676 -1.8787 -3192 6 31.2862 9.0706 13.0896 18.8649 -43.5027 -8.26415 -3193 4 31.2854 8.18164 13.5153 -0.98006 14.2242 -7.24428 -3194 4 30.8139 9.64196 13.6614 -21.2648 23.3567 24.384 -3195 6 52.8349 16.8368 29.9626 -1.04236 -5.83632 -3.7224 -3196 4 53.1314 16.3317 29.1809 4.11254 10.2245 6.81583 -3197 4 53.5336 17.4658 30.2088 5.59995 -2.32318 -6.64835 -3198 6 13.48 30.6403 11.9185 -26.7 12.8254 18.6299 -3199 4 12.8874 31.2649 12.4086 6.11749 -21.3055 -11.69 -3200 4 14.2712 31.1662 11.9231 18.3999 3.72963 -5.07782 -3201 6 24.4118 24.6653 11.1776 -11.0488 -38.9105 0.0232616 -3202 4 25.2327 25.0345 11.4834 15.6111 8.28781 8.86477 -3203 4 24.5324 23.6736 11.237 -9.01076 27.817 -2.51724 -3204 6 11.1207 26.7925 5.93063 -6.41259 2.09364 -8.23675 -3205 4 11.5241 26.98 6.79711 -3.12879 8.72791 -6.17468 -3206 4 10.8719 27.6544 5.50988 6.7003 -18.2386 15.7162 -3207 6 12.0069 32.3194 4.56559 -6.93674 1.89769 -53.2748 -3208 4 11.7104 31.8608 3.68045 16.1117 25.2499 46.2442 -3209 4 12.3686 33.2222 4.3326 -9.20365 -26.1492 2.14142 -3210 6 6.43611 5.48582 30.4705 10.9412 7.27018 -5.81208 -3211 4 6.8324 6.31983 30.1884 15.302 -0.761667 0.276275 -3212 4 5.5204 5.70213 30.4126 -22.6187 -2.98333 3.5448 -3213 6 38.1723 39.6045 29.3805 -11.1368 -0.968084 -7.99101 -3214 4 37.5332 40.3179 29.1036 12.1085 -24.1545 -0.917311 -3215 4 37.9804 38.7063 28.9788 -2.28765 36.4506 5.30967 -3216 6 52.5924 19.3736 5.41149 4.12965 0.0949992 -5.17576 -3217 4 52.3027 20.2712 5.07121 22.7239 -28.0308 -2.84369 -3218 4 53.4989 19.0543 5.10701 -28.7609 25.7225 2.66162 -3219 6 18.3561 9.81057 21.0683 -18.476 -24.6523 15.6829 -3220 4 17.6378 9.45854 20.4828 20.1245 14.4878 5.80252 -3221 4 19.033 10.2869 20.5982 6.82627 10.6552 -20.9713 -3222 6 14.5094 41.1238 15.0395 5.73538 -4.06503 -13.1796 -3223 4 15.2839 41.068 15.6075 4.55031 0.900939 7.74817 -3224 4 13.875 41.6599 15.5263 0.0235554 2.15182 4.98288 -3225 6 36.0027 23.903 26.7597 7.48895 21.6763 -35.676 -3226 4 35.8975 23.6043 27.6465 2.36908 -17.7227 17.2904 -3227 4 36.3267 23.2124 26.1374 -7.97178 4.49324 27.7844 -3228 6 35.6359 10.4157 26.2529 -13.2839 -25.1837 23.1485 -3229 4 35.969 10.5098 25.3716 5.3977 0.436992 -21.1808 -3230 4 35.4229 9.45302 26.3798 5.18698 20.1527 -7.56493 -3231 6 45.3037 24.2791 20.2723 9.06075 11.2998 -13.4968 -3232 4 45.4523 24.978 19.6109 10.2075 -1.49386 4.95329 -3233 4 44.5125 23.8555 19.9662 -13.3892 -9.58217 -2.04663 -3234 6 15.8107 39.0453 24.2393 9.7405 19.086 8.48056 -3235 4 15.3407 39.8143 24.6455 3.07287 -17.6695 -6.90152 -3236 4 16.7434 39.3626 24.1878 -22.1708 -8.11019 0.25747 -3237 6 4.61074 25.9041 16.8066 4.47487 12.325 4.32837 -3238 4 5.33363 26.3313 17.2996 -1.16871 -8.95741 -3.63592 -3239 4 3.89121 26.5439 16.91 5.27726 -3.71411 -3.28281 -3240 6 33.4791 9.99232 32.5716 -36.5508 -4.76722 -31.2046 -3241 4 34.3147 10.2419 32.89 39.2476 10.968 21.6954 -3242 4 33.0188 9.57531 33.3002 0.324125 -5.12222 10.2577 -3243 6 22.9388 37.5185 1.51191 -4.27166 -24.2064 8.31852 -3244 4 23.0334 38.2273 2.154 1.20614 3.86272 6.71724 -3245 4 22.69 36.6978 2.02191 6.96614 23.4315 -10.5782 -3246 6 39.1324 20.5485 25.4772 25.265 -11.778 19.9951 -3247 4 39.2103 21.4279 25.1215 -1.526 12.0473 -3.88318 -3248 4 39.8813 20.4818 26.1301 -17.748 -0.0581828 -14.4699 -3249 6 25.0622 25.0762 37.6014 21.4558 5.76047 -13.7935 -3250 4 26.0349 25.2337 37.6294 -19.4467 -8.38624 -4.14531 -3251 4 24.8891 24.8197 38.5048 -7.65564 -1.94532 12.2316 -3252 6 12.209 35.7591 11.4203 -9.12536 1.25056 -5.53999 -3253 4 11.4995 36.2015 10.8899 19.2305 -11.6187 8.3526 -3254 4 12.8486 35.4161 10.7797 -5.71729 7.89629 -2.43108 -3255 6 42.046 15.7235 20.1276 29.9467 5.46844 -26.2367 -3256 4 42.5818 15.5034 19.3148 -14.0105 1.75231 17.5608 -3257 4 42.3615 16.6209 20.337 -4.0808 -2.27778 2.90042 -3258 6 53.2021 25.4307 39.5282 4.69599 -13.2561 7.07883 -3259 4 53.78 25.8541 38.905 5.49131 5.5629 -6.42231 -3260 4 52.4802 26.028 39.6966 -10.1139 9.50655 0.821399 -3261 6 53.7967 21.778 1.29815 15.5744 -8.20383 1.43914 -3262 4 54.6378 21.4326 0.944441 -3.84265 -1.46767 8.18122 -3263 4 53.3536 22.1543 0.542634 -13.037 9.31425 -11.6048 -3264 6 1.93111 22.4438 20.1768 4.00387 4.12813 31.1185 -3265 4 1.5939 23.2361 20.6593 2.49828 -13.4199 -15.2591 -3266 4 2.41139 21.9607 20.8911 -6.34657 6.89732 -14.8434 -3267 6 41.1871 16.1847 11.4932 0.836017 42.0531 1.99799 -3268 4 40.9413 15.3195 11.802 -9.8633 -17.6073 7.87469 -3269 4 40.5377 16.8617 11.8588 16.4331 -27.7799 -8.96912 -3270 6 17.194 38.6096 9.61825 4.75854 -2.20459 -16.4638 -3271 4 17.8324 38.6167 10.328 10.0816 -0.610832 12.429 -3272 4 16.3385 38.6013 10.0398 -14.9506 0.593169 11.9887 -3273 6 33.2005 12.9606 38.531 8.50507 10.8774 -15.8661 -3274 4 33.6532 13.8203 38.39 -7.98235 -13.7359 5.26797 -3275 4 33.1331 12.8007 39.479 5.11874 5.24255 -4.23095 -3276 6 24.7171 21.675 39.9778 2.8762 -23.2501 -10.2076 -3277 4 24.5558 21.597 39.0096 0.45736 0.189324 11.8412 -3278 4 25.3262 20.9394 40.2143 -5.83632 9.86919 -3.30671 -3279 6 13.5803 15.5602 27.3532 26.1047 30.3564 11.1382 -3280 4 13.1676 16.145 28.014 -3.26959 -8.19558 -5.9347 -3281 4 12.973 14.8589 27.1951 -20.4184 -17.1677 1.43072 -3282 6 24.68 18.7128 9.26691 14.3839 36.3501 26.0009 -3283 4 25.3598 19.2552 8.82532 -5.31062 -15.6251 -9.27674 -3284 4 24.5166 19.2286 10.0937 -4.12977 -20.8661 -14.1648 -3285 6 10.971 8.2031 0.0820528 -5.05885 27.6393 52.7366 -3286 4 10.426 8.82187 0.676738 20.6953 -23.692 -21.2054 -3287 4 11.8511 8.19112 0.51746 -10.8092 -0.715691 -8.01276 -3288 6 15.7168 31.9426 31.3882 -16.0589 -14.8784 11.374 -3289 4 14.8784 32.0139 30.9212 -5.19427 4.39929 -5.1125 -3290 4 16.2361 32.7208 31.1626 4.51908 -4.85975 -1.07492 -3291 6 20.3853 39.1678 21.6201 3.96912 1.70678 -2.15463 -3292 4 19.8408 38.4031 21.9136 18.3946 15.2484 5.21077 -3293 4 21.1259 39.3411 22.2478 -18.5683 -14.4588 -3.61544 -3294 6 38.8575 19.5345 7.60357 -3.22682 7.2187 -10.7103 -3295 4 37.9955 19.1157 7.58645 -3.56529 1.50397 -1.646 -3296 4 39.2183 19.2349 8.43232 7.58358 -7.76078 7.45775 -3297 6 41.3566 29.7161 21.1634 -18.4754 -13.1658 17.2704 -3298 4 41.7904 29.7702 20.3348 3.95998 3.00501 -30.3792 -3299 4 42.0386 30.0045 21.7486 9.4821 7.67994 22.7786 -3300 6 50.7055 33.8359 22.0677 10.0235 -14.5617 12.8511 -3301 4 51.0634 32.983 22.4061 -4.7136 19.0099 -8.42991 -3302 4 50.4062 33.6539 21.1646 0.0172424 0.211956 1.78818 -3303 6 18.1576 11.1602 14.3564 -14.1594 -3.53412 4.86119 -3304 4 18.0624 11.3441 15.3149 3.69196 -2.83217 -14.991 -3305 4 19.1071 11.0831 14.1997 2.21718 -0.861887 0.62752 -3306 6 48.509 14.2737 15.2536 -33.8512 -15.7039 -13.3543 -3307 4 49.4102 14.4821 15.4142 31.3042 4.03673 3.1002 -3308 4 48.4635 13.5769 14.5611 0.497508 10.2707 10.4073 -3309 6 32.9892 15.7452 8.24788 15.5762 1.59093 3.47394 -3310 4 33.8184 15.532 7.78513 -5.99942 0.288096 4.45585 -3311 4 33.1922 15.7362 9.20789 -3.05234 -0.622843 -13.6288 -3312 6 42.9176 4.85532 18.7629 14.1748 1.41964 3.40057 -3313 4 42.9882 5.82921 18.9229 4.77982 -22.1758 1.39114 -3314 4 43.8043 4.45344 18.9624 -18.3785 17.0247 -7.93082 -3315 6 10.5031 23.7237 33.4382 -0.874073 19.9298 2.74355 -3316 4 10.5548 24.717 33.3795 7.7257 -28.8706 -7.54496 -3317 4 11.1379 23.281 32.8547 0.735263 11.3428 1.89897 -3318 6 1.13216 20.0583 11.2836 18.374 17.5884 12.1148 -3319 4 0.491024 19.3349 11.1994 -2.17247 3.20995 10.4498 -3320 4 1.13554 20.5377 12.169 -13.4236 -25.5013 -29.3002 -3321 6 1.52072 39.5358 14.3069 -1.86369 -19.4721 11.7014 -3322 4 0.846705 40.1803 14.5938 4.14733 -5.95668 -5.60613 -3323 4 1.29368 38.6598 14.724 6.32152 28.9753 -9.07681 -3324 6 8.31775 21.6111 14.1387 -15.017 -6.93379 31.3726 -3325 4 8.13664 21.1659 15.0266 4.22851 15.111 -30.7591 -3326 4 7.52757 21.5034 13.5919 -1.9589 1.09648 1.01763 -3327 6 7.16491 13.3069 38.2405 -3.91014 1.61314 -29.5843 -3328 4 6.63698 13.0539 37.4502 4.01765 -4.94514 23.7112 -3329 4 7.51249 14.1719 37.966 2.17516 -8.38294 10.659 -3330 6 46.6268 1.62726 18.6981 -5.20766 -2.9114 16.5849 -3331 4 47.5711 1.68468 18.9367 -9.38594 -0.162468 5.90612 -3332 4 46.1191 1.48652 19.5414 20.1897 3.23395 -16.531 -3333 6 4.07867 8.38347 14.797 30.0262 18.9917 2.43531 -3334 4 3.34187 8.3175 15.3794 -25.1937 -7.21885 10.0707 -3335 4 3.92422 7.81173 14.052 -7.87119 -13.0009 -15.9092 -3336 6 47.5843 36.535 17.848 27.4213 12.0237 5.93301 -3337 4 47.2301 35.69 17.6416 -25.9655 -28.1947 -7.00186 -3338 4 48.5203 36.321 17.8356 11.6458 7.4707 2.49139 -3339 6 48.7172 32.6081 3.62434 16.9155 19.6851 -27.3563 -3340 4 49.4676 32.1613 3.18145 -8.8052 -0.0369675 17.0972 -3341 4 48.3534 32.1141 4.33579 -5.12692 -24.8974 22.5299 -3342 6 26.8624 34.4063 15.194 -5.61502 8.38998 -0.355377 -3343 4 27.128 33.6719 15.7603 3.91671 -4.37186 -8.54489 -3344 4 27.3784 34.3384 14.3661 -3.09932 -5.4603 13.6569 -3345 6 9.98983 27.3411 13.3236 -5.30345 -60.6937 -19.0037 -3346 4 9.94192 28.2179 13.0053 -1.51785 37.2293 -13.4128 -3347 4 9.87191 26.7487 12.5139 4.66007 24.2176 27.9858 -3348 6 2.39898 26.8872 37.357 1.59401 -7.29113 19.9813 -3349 4 2.39832 26.7504 38.3162 -5.28205 -0.510768 -0.23331 -3350 4 3.33711 26.9514 37.1904 14.8183 3.44774 -11.9786 -3351 6 33.3368 17.2756 36.8005 -23.2882 7.84328 1.94786 -3352 4 32.371 17.4043 36.8526 5.24602 0.476467 11.7287 -3353 4 33.4423 17.1515 35.8622 12.5187 -3.29866 -15.2334 -3354 6 10.6624 18.8035 9.30575 -3.98781 15.2275 -14.7508 -3355 4 10.7339 18.764 8.32616 -2.59554 -5.92059 15.2764 -3356 4 10.8972 19.732 9.49452 -1.55193 -6.4517 3.37647 -3357 6 8.57833 27.4047 3.14019 -5.09403 -6.13324 -2.85576 -3358 4 8.57126 27.6547 4.08504 -2.7611 -8.03155 -6.83353 -3359 4 8.4622 26.4231 3.09919 3.19624 23.0742 12.9307 -3360 6 40.6073 33.9264 14.3399 -6.85038 20.2562 -23.9123 -3361 4 40.863 33.245 14.948 0.807967 -8.16399 15.1571 -3362 4 40.0779 34.5716 14.8204 -0.495244 -4.69725 4.10141 -3363 6 53.9925 16.7992 13.6308 6.31935 -7.9338 28.1888 -3364 4 54.0997 17.1551 12.7528 -11.031 14.1585 -18.9596 -3365 4 53.1709 17.0486 14.0912 -3.14305 7.59696 -13.573 -3366 6 39.1497 38.4912 7.40608 -39.1223 4.05884 30.5073 -3367 4 38.8859 38.5922 6.48797 -2.00378 4.08479 -3.77896 -3368 4 38.3062 38.5986 7.97667 35.5804 -2.74434 -28.8566 -3369 6 42.2129 33.6808 29.0138 -24.1371 3.42921 -11.8129 -3370 4 42.1057 34.6378 28.7577 -2.98627 -25.8941 0.854821 -3371 4 41.3475 33.1819 28.8496 28.8118 27.0492 8.45917 -3372 6 2.85866 0.0629173 20.1315 -20.2536 1.52979 -19.4947 -3373 4 2.75203 0.421025 19.2221 8.85994 -2.20895 9.93397 -3374 4 1.96017 41.6124 20.299 15.6791 2.4666 6.01858 -3375 6 24.986 26.9373 24.4454 -5.13687 18.0728 7.96565 -3376 4 25.2851 26.0172 24.3926 4.88984 -3.86206 4.04103 -3377 4 25.2923 27.4081 25.2509 0.579281 -17.4573 -11.648 -3378 6 13.6179 33.9875 7.01366 -9.87556 12.4155 -39.0476 -3379 4 14.4287 33.6264 6.65472 5.99816 -4.92128 6.68342 -3380 4 13.2096 34.3429 6.17379 4.4552 -5.00021 31.0775 -3381 6 17.6494 31.8378 3.38868 3.47258 32.8259 -24.0658 -3382 4 17.3179 32.0585 2.49435 6.00696 -1.44586 18.975 -3383 4 17.3532 30.9566 3.5196 -11.0767 -31.773 11.9025 -3384 6 31.1111 29.8483 35.9167 13.6376 7.61418 -14.6842 -3385 4 30.4141 29.611 36.5018 -19.519 -6.65958 16.6428 -3386 4 31.8988 29.4329 36.2727 4.98993 0.410401 2.8928 -3387 6 31.4643 1.69164 1.93808 20.5111 47.6543 28.2436 -3388 4 30.8038 1.05919 1.86135 -35.916 -50.7273 -13.0106 -3389 4 30.9957 2.32106 2.5233 13.9145 -2.66096 -10.7861 -3390 6 13.7147 9.36591 12.3063 -10.8769 -31.3803 3.40225 -3391 4 14.006 10.2311 12.0687 5.19854 25.7457 4.3425 -3392 4 13.2135 9.34561 13.1466 7.78847 9.513 -6.56361 -3393 6 15.2882 15.1512 12.1315 -28.7349 -8.10496 1.75886 -3394 4 14.285 15.1274 12.2085 32.3197 -4.02875 -3.81405 -3395 4 15.5527 14.5676 11.4001 -6.69875 1.91641 1.76342 -3396 6 44.9132 30.4441 13.088 -39.1187 -0.31911 18.6923 -3397 4 45.3561 30.6438 13.8967 -2.95974 2.37903 28.1101 -3398 4 45.6316 30.4633 12.5179 38.3165 -3.24606 -51.9295 -3399 6 35.1465 37.623 24.8576 -14.1582 -15.7359 28.7413 -3400 4 34.5779 38.3725 25.1706 10.6028 -16.3472 -5.82963 -3401 4 34.9593 36.856 25.4995 5.71155 29.9045 -22.7235 -3402 6 43.8948 19.2936 12.9987 -2.30513 -18.2146 13.0469 -3403 4 43.787 18.3102 12.9069 2.76315 21.1578 4.09431 -3404 4 44.375 19.4187 13.8444 -6.58761 -4.34429 -6.9628 -3405 6 14.1971 27.3925 16.8971 2.69526 11.3314 -20.1154 -3406 4 13.4533 26.7979 16.9981 -2.42546 -10.6182 5.16389 -3407 4 14.0783 27.734 15.9851 5.1255 -3.8968 13.4589 -3408 6 5.08574 37.4729 15.7377 1.34169 3.72011 38.8669 -3409 4 5.88395 37.4897 16.2981 -4.65405 2.63162 7.63907 -3410 4 5.46406 37.2335 14.9215 11.9791 -13.9554 -41.5179 -3411 6 35.4862 36.9766 33.2333 -36.83 -5.70901 2.9599 -3412 4 36.4114 37.1444 33.1615 28.5824 10.2327 4.96708 -3413 4 35.1164 37.4942 33.9725 5.15458 -1.79752 -2.84758 -3414 6 6.636 31.7097 32.9848 -22.7133 -7.33235 -24.9389 -3415 4 7.22761 30.9741 32.8206 4.14198 -5.34147 5.16294 -3416 4 6.9999 32.2337 33.6789 14.5784 9.31919 13.8511 -3417 6 31.283 20.2175 25.4647 -9.91499 -1.61286 9.73388 -3418 4 30.5344 20.24 26.1037 18.6204 0.149313 -5.83605 -3419 4 30.8734 20.4846 24.6365 -0.167457 4.09649 -2.99843 -3420 6 54.9487 26.0868 7.35258 -28.6285 -0.216784 1.76255 -3421 4 54.2955 26.5615 6.794 6.74078 -5.97369 7.99882 -3422 4 54.4034 25.6757 8.0611 9.89476 6.61779 -10.5703 -3423 6 17.8651 35.1614 24.3791 -20.7499 -4.98646 -29.5673 -3424 4 18.0576 34.6235 25.1649 -8.37985 -1.7243 -11.1178 -3425 4 17.2007 34.681 23.779 26.831 10.1018 28.2803 -3426 6 49.1285 3.31358 19.7417 -8.45795 -3.91869 -17.1851 -3427 4 48.8119 4.11203 20.1653 -3.29153 9.9905 4.05996 -3428 4 49.7807 2.96094 20.3466 4.32541 -4.85853 3.16639 -3429 6 30.2844 35.6035 13.4934 7.2001 -0.317469 -2.452 -3430 4 29.4623 35.659 12.9857 1.71884 -1.71824 2.45729 -3431 4 30.0585 35.4328 14.4204 -4.00669 1.3983 -5.34585 -3432 6 43.3887 25.8808 41.6785 -22.9069 -12.3923 -2.55701 -3433 4 43.9997 25.6768 40.9817 12.0928 0.211006 -14.0269 -3434 4 43.8339 26.4255 0.397834 14.8568 14.8319 19.2759 -3435 6 21.0884 23.1529 6.38678 -1.35916 1.28851 13.8592 -3436 4 21.4 23.8645 6.98768 -5.78702 -12.5756 -9.70729 -3437 4 21.3246 23.4545 5.51028 2.40121 5.3387 -13.5131 -3438 6 54.6143 21.1989 19.0895 1.0726 18.3039 13.0104 -3439 4 0.43531 21.5582 19.5367 -15.0683 -8.68203 -12.1911 -3440 4 53.867 21.7044 19.4937 16.3508 -9.47613 -7.9193 -3441 6 13.877 38.9443 18.7624 -3.57764 -10.5141 -5.7706 -3442 4 13.4493 38.4672 19.4981 1.6116 7.10734 -3.21136 -3443 4 14.0821 39.8514 19.0249 -5.40993 2.00969 6.25434 -3444 6 39.1872 2.73234 39.6824 0.14108 0.727177 -8.14712 -3445 4 38.529 2.27328 40.2354 4.03816 -1.16808 -5.22543 -3446 4 39.0548 2.41866 38.7627 -6.48078 -0.982324 12.2661 -3447 6 43.2185 33.8148 8.84061 -19.4182 46.8926 -2.36482 -3448 4 43.1772 32.9719 9.24022 -1.50187 -35.3898 17.2737 -3449 4 42.5163 34.3616 9.29053 19.0727 -15.0644 -10.6104 -3450 6 23.089 16.6827 12.1027 15.7208 -3.2574 -7.89972 -3451 4 23.4385 16.1911 11.3228 -11.6069 8.24456 13.4993 -3452 4 22.136 16.8018 11.9813 0.424679 -1.38664 -3.29845 -3453 6 40.7855 26.1389 36.3196 -19.9126 19.309 9.87347 -3454 4 40.0986 26.8534 36.2514 19.4153 -21.5003 1.38126 -3455 4 41.1517 26.0031 35.4437 4.25962 0.995192 -8.54639 -3456 6 15.1503 11.6717 19.2973 0.724699 -1.19191 17.6918 -3457 4 15.5299 12.2877 18.6792 5.27756 8.7759 -18.41 -3458 4 15.4868 12.0294 20.1269 -4.65024 -4.08223 3.58338 -3459 6 9.86165 29.8154 31.387 -8.94942 -10.7424 5.06077 -3460 4 10.5846 30.1184 31.9716 0.245343 7.83947 -17.0155 -3461 4 9.856 30.1645 30.4637 12.8302 0.479173 21.4055 -3462 6 2.12473 30.035 25.2763 1.78753 8.3758 2.85176 -3463 4 2.08519 29.2167 25.7943 1.54705 3.16986 -12.4779 -3464 4 2.12365 29.8679 24.3136 0.147535 -6.31004 19.3474 -3465 6 49.0081 10.6471 7.05663 3.22839 15.7191 0.010386 -3466 4 49.8069 10.5015 7.59507 -11.7369 -5.9273 -2.35907 -3467 4 48.4474 9.86293 7.09337 3.15572 -10.0552 5.75386 -3468 6 38.6524 34.4248 32.4903 14.0617 12.8107 -4.97275 -3469 4 38.3124 35.2999 32.7524 2.4491 -7.54743 -1.61947 -3470 4 38.3152 33.7696 33.1015 -5.90625 -1.07654 6.02858 -3471 6 24.2925 24.7077 4.76791 -9.60212 12.423 13.627 -3472 4 24.6592 23.9059 5.14091 6.4374 -12.2494 -4.05598 -3473 4 24.0877 25.2629 5.55261 2.76703 -5.61196 -18.2913 -3474 6 44.0394 23.5955 33.7722 -22.1761 -10.7316 25.8053 -3475 4 43.54 23.0408 33.1405 14.8275 10.6039 0.934173 -3476 4 44.7909 24.0173 33.3845 18.136 8.68259 -21.6513 -3477 6 45.1404 31.9557 26.6336 7.63501 -16.8517 -19.5705 -3478 4 44.7419 32.078 27.4825 -5.98757 6.26965 19.5048 -3479 4 44.9572 31.0195 26.4087 0.928196 13.8489 4.22851 -3480 6 52.067 6.35346 22.8527 -23.4258 -19.9992 -0.226773 -3481 4 51.4359 5.65775 23.1792 22.6487 15.1416 -4.78776 -3482 4 51.473 7.11391 22.7826 5.97124 1.02094 -2.8274 -3483 6 5.11659 17.7141 30.4608 -43.6072 -14.7819 8.36724 -3484 4 5.56343 17.5578 29.6371 20.9412 3.52217 -11.7922 -3485 4 5.63141 18.2128 31.0754 22.7819 13.5036 5.79607 -3486 6 48.537 17.0137 6.52887 28.2349 12.1042 -25.3981 -3487 4 48.2628 16.1023 6.56372 -5.81913 -12.4107 2.5618 -3488 4 49.2494 17.0592 5.82246 -25.6562 2.24824 21.9849 -3489 6 13.808 31.3142 23.4689 -3.64011 -9.68131 26.3432 -3490 4 14.1349 31.2178 24.3617 -12.0329 4.75192 12.2102 -3491 4 14.6149 31.173 23.0226 30.8248 -5.26015 -34.1434 -3492 6 28.4946 33.4369 26.0285 16.4638 25.2333 -6.25798 -3493 4 28.7216 32.7387 25.4298 8.48672 -9.67688 -13.795 -3494 4 27.7897 33.0868 26.5316 -24.4903 -9.494 23.2581 -3495 6 9.0435 22.9594 11.008 21.162 0.605596 1.29652 -3496 4 9.33306 22.7779 10.1087 -4.82127 0.713158 -4.26872 -3497 4 9.8456 22.7632 11.5172 -9.5186 2.48902 2.0044 -3498 6 40.5545 4.06728 26.5809 44.6249 -53.7912 6.90123 -3499 4 40.0988 4.06982 27.4038 -17.0162 4.47424 24.8249 -3500 4 40.1579 4.71783 26.0744 -31.5116 46.4114 -32.7723 -3501 6 17.0554 37.9737 20.9489 23.2001 5.84937 -15.1211 -3502 4 17.8184 37.6206 21.4529 -18.1961 -0.773306 2.14347 -3503 4 16.241 37.9215 21.4323 -8.54619 -6.77157 16.0583 -3504 6 31.9589 6.36634 14.2007 -32.7312 -5.18635 1.31695 -3505 4 31.6173 5.45206 14.3159 2.63352 8.72785 -2.4018 -3506 4 32.9006 6.25378 14.1536 18.2531 -4.45925 -0.605861 -3507 6 29.3682 34.9487 39.6588 1.61784 2.82525 -17.5597 -3508 4 29.3689 34.7576 40.5935 -6.77547 -0.101859 12.4897 -3509 4 28.4273 35.0463 39.4168 8.43037 -3.37269 4.33216 -3510 6 22.5699 2.93494 32.1141 -1.63629 -8.86743 4.25418 -3511 4 23.0898 3.67063 31.7669 1.49018 1.71101 -1.29845 -3512 4 22.818 2.15292 31.5827 -1.92581 11.5593 5.09528 -3513 6 51.7444 19.0899 24.8018 18.5566 14.3159 27.8709 -3514 4 52.1262 19.3991 25.6728 -16.855 -8.06891 -29.5747 -3515 4 52.1578 19.634 24.1129 -3.61196 1.33098 2.20453 -3516 6 32.1137 13.664 24.2226 6.2567 1.72658 -37.8727 -3517 4 32.2307 13.7857 25.1378 6.97488 6.10606 45.7276 -3518 4 31.1794 13.5551 24.0935 -22.8325 -3.39176 -1.92521 -3519 6 9.48788 30.1788 28.8037 -7.90151 -0.480281 -10.0021 -3520 4 9.04214 29.3907 28.4657 0.296662 -4.58444 4.12418 -3521 4 9.71381 30.648 27.9899 1.85323 2.91474 4.33114 -3522 6 31.3027 3.12343 24.087 3.70677 4.08208 -3.18372 -3523 4 30.8363 3.94541 23.9161 -7.21645 -1.79011 2.75115 -3524 4 32.1629 3.26377 23.6687 3.35255 -5.74571 3.4439 -3525 6 2.14326 19.8385 36.4613 43.5578 -10.0216 -16.9659 -3526 4 3.05142 19.7594 36.0352 -31.8637 8.98539 19.2185 -3527 4 1.69253 19.0555 36.1346 -14.6763 0.545221 1.96285 -3528 6 36.957 16.7591 14.0918 2.96563 -13.2358 -6.51153 -3529 4 37.0513 17.1687 14.9682 1.23982 -3.45998 -2.6752 -3530 4 37.3406 15.8552 14.1067 -4.20166 12.9403 2.86695 -3531 6 1.82327 11.1921 6.0808 -0.275886 9.47834 -4.04825 -3532 4 1.66503 10.3513 6.51275 0.636708 -7.94921 -0.277572 -3533 4 1.41092 11.8149 6.68093 -3.53423 6.76721 2.7814 -3534 6 43.1526 36.8455 25.2619 -8.14588 -11.3328 3.19442 -3535 4 42.3648 36.774 24.6888 4.17675 -0.750929 11.0286 -3536 4 43.0263 36.2034 25.9927 3.18182 11.8936 -13.2388 -3537 6 32.1279 5.54767 7.01242 2.49094 2.37791 -5.83138 -3538 4 31.9279 4.68363 7.38152 0.218816 -4.41428 4.71371 -3539 4 31.563 6.18782 7.45455 -6.02642 2.24751 5.27561 -3540 6 15.066 21.4965 41.5173 26.6113 -14.2353 0.879596 -3541 4 14.4098 21.4318 0.299313 -13.8163 5.2854 1.00244 -3542 4 14.7314 21.9782 40.7628 -14.3918 6.6959 -6.38566 -3543 6 37.0263 36.0654 5.67599 -8.66989 11.0394 5.08886 -3544 4 36.7926 36.9074 5.26668 1.42879 3.21556 -9.50708 -3545 4 36.6993 36.1724 6.58455 6.67811 -8.44617 -2.15326 -3546 6 39.6264 22.8802 0.345968 -6.61229 0.0560669 1.87747 -3547 4 39.9979 23.7083 41.9266 1.97423 1.58642 1.0556 -3548 4 39.8106 22.8717 1.30105 -0.716498 -2.72173 1.5866 -3549 6 18.4762 23.1875 5.24196 -3.43754 -16.0644 -0.1002 -3550 4 18.2109 24.0785 4.97873 9.26343 12.8459 2.1419 -3551 4 19.3202 23.1705 5.73113 -5.23082 11.7415 -3.58503 -3552 6 34.4866 26.3931 0.410981 -26.1443 -19.9516 50.1306 -3553 4 33.9706 27.0567 0.94736 13.8106 -10.3269 -20.7381 -3554 4 34.4077 25.5868 1.01915 10.7474 25.1704 -28.4611 -3555 6 28.1474 26.0925 40.6196 -28.5345 -18.6936 36.4955 -3556 4 29.0529 26.0026 40.9247 9.18224 2.32741 -2.79367 -3557 4 27.6107 25.644 41.3519 15.6172 17.8969 -31.6189 -3558 6 41.7482 4.39863 30.2421 -5.41295 4.8086 27.4354 -3559 4 42.5847 3.93131 30.2216 8.80522 -6.59194 -7.61494 -3560 4 41.6924 4.68152 31.1831 -5.94926 -0.146025 -12.4776 -3561 6 4.45598 8.30655 29.1222 20.5127 -16.5965 8.52389 -3562 4 3.66946 8.7156 28.7677 -9.60933 13.4518 -0.978151 -3563 4 4.96147 8.97819 29.6123 -10.8114 0.933443 -7.64816 -3564 6 12.9096 9.61234 32.1411 7.95239 -11.3181 7.67023 -3565 4 12.5174 8.82681 31.7782 -9.40951 -4.97415 -8.25208 -3566 4 13.381 9.26623 32.9076 3.83436 11.6436 3.42456 -3567 6 48.6608 16.2478 1.44826 -41.5847 5.12436 -2.24268 -3568 4 49.5977 16.2655 1.51923 27.6715 2.95254 13.2549 -3569 4 48.2356 16.5221 2.2956 18.9339 -8.30142 -14.6437 -3570 6 26.4307 40.0076 21.1903 -9.81311 41.2665 6.04236 -3571 4 27.1749 40.6498 21.1967 -8.04845 -12.0635 0.822588 -3572 4 26.7755 39.1508 21.0026 13.0624 -20.4442 -2.17563 -3573 6 35.79 4.08177 9.00682 -31.6066 0.334495 -4.41207 -3574 4 35.483 4.74976 8.36033 1.0784 -4.66377 5.72074 -3575 4 35.0087 3.86601 9.59196 22.2264 5.21899 -16.6494 -3576 6 52.6895 3.55332 27.8634 16.2443 -8.90238 -17.7273 -3577 4 53.4861 3.5089 28.4695 -19.2533 -5.0216 -23.8454 -3578 4 52.9436 3.34738 26.8904 -3.28408 11.0051 45.9059 -3579 6 48.3169 26.6974 27.3926 25.9077 -23.6746 5.28014 -3580 4 49.0048 25.9927 27.5456 -25.7263 19.495 -6.18754 -3581 4 48.6886 27.4598 27.8411 -2.12981 11.4596 4.51315 -3582 6 24.5097 4.95686 18.7286 -11.1396 -9.34012 13.2359 -3583 4 24.0942 4.18073 19.1756 8.31772 16.1923 -9.35863 -3584 4 23.9484 5.73893 18.8892 6.66511 -10.1227 -0.689949 -3585 6 24.0567 12.4804 28.7686 -1.83015 0.889486 -1.95598 -3586 4 23.1997 12.8888 28.9043 -2.54864 9.49841 4.61676 -3587 4 23.8244 11.6446 28.3683 7.90245 -6.62953 -5.67748 -3588 6 40.1561 27.7426 40.8073 -21.5317 7.14576 -7.35733 -3589 4 40.4932 26.962 41.2601 -12.917 0.0491148 -0.726507 -3590 4 39.1936 27.5721 40.6401 25.9681 1.33069 1.19471 -3591 6 11.9274 13.5458 26.9496 -4.40765 -1.96337 -6.60028 -3592 4 10.9986 13.6678 27.167 -4.51497 -1.32563 0.190923 -3593 4 12.2404 12.8654 27.5442 6.31176 -11.0874 3.59056 -3594 6 52.1902 29.5387 41.394 18.594 -11.3781 3.59259 -3595 4 51.989 30.3087 0.0068425 -9.85392 15.5397 4.91192 -3596 4 53.1003 29.3208 41.6912 -5.64389 -6.04423 -8.59676 -3597 6 17.4867 19.0227 39.1838 -6.27455 21.666 2.75279 -3598 4 17.488 19.586 40.0024 0.860103 -14.9947 -21.9977 -3599 4 17.2876 19.5951 38.4014 5.36511 -12.0476 21.2649 -3600 6 46.2283 27.6807 33.7144 -6.74129 13.676 11.5468 -3601 4 46.0876 28.3582 33.0447 4.86435 -1.49715 -10.0026 -3602 4 45.6533 27.9743 34.4365 0.457797 -3.70748 6.99028 -3603 6 35.8353 29.5439 5.61992 2.49906 -1.59566 -19.7219 -3604 4 35.6527 29.5233 4.66367 4.90114 -0.621078 3.19465 -3605 4 35.4473 30.3766 5.88547 -3.82587 11.7884 10.6864 -3606 6 47.2822 25.7798 30.1513 -10.5766 8.53329 -17.9568 -3607 4 48.1664 25.813 29.7363 -13.2628 3.84456 1.19765 -3608 4 46.6616 26.387 29.6551 21.0058 -12.1546 6.47151 -3609 6 51.3953 12.3638 20.0228 -1.62023 8.46277 -4.73872 -3610 4 50.7529 12.7462 19.4094 4.65296 3.97806 -1.37635 -3611 4 50.8736 11.6867 20.4477 2.10356 -10.8225 11.04 -3612 6 41.9857 18.3757 28.9464 12.9674 -8.39178 -20.9845 -3613 4 42.6678 18.0249 28.3214 -8.5661 8.58724 12.8041 -3614 4 42.4509 18.9846 29.5329 1.95722 -2.13958 -2.01301 -3615 6 53.5955 6.47736 7.49747 -17.4879 -34.0434 -11.6994 -3616 4 53.215 5.56736 7.34717 12.2612 27.0176 1.32153 -3617 4 53.8473 6.47025 8.42428 8.27981 0.813073 3.28926 -3618 6 9.90701 10.6092 26.7593 2.25524 -7.80823 -0.160956 -3619 4 10.2937 10.2906 27.6083 -8.74192 13.2514 -11.8083 -3620 4 9.6719 11.5504 26.8324 5.3909 -8.28719 7.73453 -3621 6 9.32838 39.4044 29.7661 28.1478 19.087 17.9947 -3622 4 10.1636 39.3682 30.3277 -29.6144 2.71186 -18.0569 -3623 4 8.79772 40.1574 30.1092 9.7156 -13.1012 -9.05156 -3624 6 33.3969 4.77935 0.0338577 7.04977 -8.48101 -1.75146 -3625 4 33.7652 5.5373 41.4968 -3.54645 16.0087 -2.35532 -3626 4 34.1271 4.15493 41.8774 -6.76144 -3.49152 6.70786 -3627 6 35.7118 10.6691 34.2465 30.5451 -20.2214 -10.6481 -3628 4 35.199 10.7815 35.0349 -14.696 6.44481 20.012 -3629 4 36.4515 10.0721 34.5187 -16.7263 14.6249 -6.06398 -3630 6 15.1941 17.3851 19.1797 2.70911 -28.1342 -44 -3631 4 15.4897 16.9339 18.3047 -12.3876 19.7973 41.7399 -3632 4 14.2542 17.5546 19.0074 0.407714 2.19657 2.29796 -3633 6 17.478 37.6645 15.4329 -18.9254 1.45878 17.8737 -3634 4 16.9549 37.8023 16.2867 26.4617 -7.60783 -22.0624 -3635 4 18.4074 37.4659 15.6333 -6.79317 3.25497 7.31584 -3636 6 26.2497 8.20945 21.7084 13.406 8.66037 11.1677 -3637 4 26.4123 8.51714 22.643 -13.4745 -7.28424 -22.9055 -3638 4 25.3027 8.1176 21.5293 -5.49097 3.27453 10.4234 -3639 6 0.34 9.90937 15.4047 -28.932 15.8312 -5.67551 -3640 4 1.21626 9.57115 15.2747 8.47529 -16.8828 -5.88536 -3641 4 54.6903 9.41637 14.8207 22.8064 6.49071 10.4803 -3642 6 13.4564 40.6532 9.29599 -22.1307 -5.15585 -0.326819 -3643 4 12.4714 40.4452 9.30279 34.033 7.20134 3.90171 -3644 4 13.9359 39.9749 9.79874 -9.44555 -0.536228 -2.64909 -3645 6 49.5525 25.9167 33.0087 8.30289 -20.978 36.7812 -3646 4 50.1102 25.581 33.7998 -31.2394 16.5759 -41.6702 -3647 4 48.6381 25.5592 33.0807 18.1841 3.33668 -0.378289 -3648 6 37.0921 40.0433 26.4323 -69.9693 32.9093 31.9949 -3649 4 36.1848 39.6472 26.7001 50.2617 0.87061 -16.3943 -3650 4 36.887 40.9984 26.66 23.4133 -30.5831 -16.8038 -3651 6 47.9876 17.8592 12.1588 -8.21233 14.3088 -32.1086 -3652 4 47.5845 18.6288 11.6747 8.44083 -19.6159 16.8154 -3653 4 47.7143 17.8826 13.0665 -7.39134 3.08395 19.3289 -3654 6 27.9663 29.0642 34.1603 1.53587 -18.0299 -1.74725 -3655 4 28.882 28.804 34.3498 -7.37789 1.41773 -2.30399 -3656 4 27.9529 30.0159 34.1809 1.22694 21.8088 1.61581 -3657 6 34.0029 2.78452 13.2168 -24.1529 16.185 8.10865 -3658 4 33.6393 2.32953 13.9926 -4.91269 2.52718 -2.68734 -3659 4 34.7844 2.29731 13.0428 30.2788 -14.7346 -8.06408 -3660 6 28.44 36.053 11.4482 -19.9886 -0.916941 20.5685 -3661 4 28.0041 35.3416 10.9605 0.296796 1.69001 -2.92558 -3662 4 29.0597 36.4216 10.8465 18.9417 8.99323 -20.1084 -3663 6 36.1834 11.364 28.8528 2.80179 -1.8504 -16.6465 -3664 4 35.2026 11.3648 28.9433 17.0081 -1.44193 -10.527 -3665 4 36.4266 11.2403 27.8881 -16.5332 2.0664 24.3605 -3666 6 24.8155 39.488 16.899 1.95651 8.69094 -17.2938 -3667 4 24.2729 40.277 17.0547 2.68209 -2.76325 7.28198 -3668 4 24.7648 39.3887 15.9322 -0.898649 -0.731043 6.96785 -3669 6 49.9432 8.0514 22.8505 -60.8038 -24.1516 -13.0827 -3670 4 49.7668 7.94962 23.7845 10.2147 3.57848 16.1239 -3671 4 49.0378 7.75433 22.5026 41.2245 11.1916 1.13457 -3672 6 52.0935 19.338 10.2277 12.6357 -4.19253 18.0692 -3673 4 51.6063 19.2592 9.39778 1.74616 10.4418 -3.52762 -3674 4 52.4735 20.2434 10.294 -12.5007 -15.5081 -12.5544 -3675 6 24.8386 15.8838 6.12895 -18.3448 14.0073 -0.236232 -3676 4 24.2024 16.3229 6.74681 14.2411 -11.6767 -8.77744 -3677 4 24.4989 16.1625 5.25788 7.11766 -3.93298 6.13727 -3678 6 49.3148 23.6851 8.6303 24.9689 -39.379 16.691 -3679 4 49.2746 22.9584 9.31909 -7.63259 29.9964 -23.4819 -3680 4 48.4638 24.0489 8.3953 -15.5352 0.433996 3.53825 -3681 6 0.208059 10.6481 32.1797 22.1875 -2.28391 4.69689 -3682 4 1.08388 10.2912 32.3483 11.827 -2.86298 -20.6213 -3683 4 54.878 10.581 33.0649 -30.4469 3.74284 18.7822 -3684 6 12.5874 32.9143 13.2407 -35.4131 4.94433 4.95913 -3685 4 11.7345 33.4182 13.1185 22.1299 -14.9844 2.19911 -3686 4 13.2795 33.4792 12.9271 13.1216 10.0242 -5.44208 -3687 6 21.734 32.5657 14.1089 -30.2641 -10.609 17.8788 -3688 4 21.1735 33.3586 14.1938 13.4775 0.171544 -7.80997 -3689 4 21.2373 31.9121 14.6504 18.4585 12.3126 -12.4653 -3690 6 48.1656 34.8484 27.3207 -34.4178 -12.3509 -32.6658 -3691 4 47.5287 35.1179 27.9926 9.598 2.53078 9.45385 -3692 4 47.5616 34.4813 26.6056 29.2581 12.2879 19.461 -3693 6 45.6153 31.2627 36.0943 -37.261 16.4569 21.0579 -3694 4 45.7916 31.8927 35.3904 -0.807743 4.61331 -8.81752 -3695 4 44.8366 31.6277 36.6156 19.759 -7.25665 -17.1647 -3696 6 46.2873 0.296503 14.3622 0.346279 -8.22198 0.0964187 -3697 4 46.2502 1.23933 14.2464 -13.6881 13.1616 4.37405 -3698 4 47.2018 42.0236 14.1712 14.709 -12.2876 -2.23521 -3699 6 14.3299 18.994 40.2006 -30.7379 -32.6603 -9.06287 -3700 4 14.4791 19.2338 39.2972 7.93482 8.11578 -14.4624 -3701 4 14.6855 19.6458 40.7662 17.9566 28.0241 18.1173 -3702 6 14.5596 1.14026 10.2341 26.3279 -2.23148 -9.5451 -3703 4 15.4055 1.22344 9.73443 -17.3894 7.51472 10.761 -3704 4 14.1379 0.381418 9.8097 -7.55267 -3.97863 3.86231 -3705 6 34.4334 40.9199 12.9894 -0.940803 4.29697 -17.7271 -3706 4 34.039 40.5607 12.1545 5.82782 2.6847 22.9711 -3707 4 34.273 40.3011 13.7266 -2.01031 0.481385 -16.696 -3708 6 42.1477 25.6267 33.9881 24.0417 -24.4569 -2.75436 -3709 4 41.6299 25.3559 33.2134 -0.0206438 0.202706 6.41118 -3710 4 42.855 24.9213 34.0976 -22.0628 21.5276 -5.85955 -3711 6 29.1852 22.5895 40.0737 -4.6165 -6.65381 -10.571 -3712 4 28.5947 23.1672 39.581 -0.582997 4.41945 3.85107 -3713 4 29.0675 22.7332 41.0074 -2.93269 3.94269 10.2267 -3714 6 44.8062 18.6252 1.49818 5.72139 3.58279 15.6322 -3715 4 44.9314 18.8801 2.44529 -3.9019 -2.65234 -18.9387 -3716 4 44.0985 19.1782 1.14518 3.29812 2.13948 3.69359 -3717 6 4.47265 10.8135 23.9407 -24.2902 -18.4562 11.3409 -3718 4 5.11906 11.4142 23.6391 22.3407 21.5355 -19.7447 -3719 4 4.51291 10.8829 24.8932 -6.80118 0.381125 6.4492 -3720 6 6.46087 23.0097 28.9948 -0.180046 29.3158 3.74757 -3721 4 7.16357 23.1777 29.6697 -12.977 -15.1924 -17.9731 -3722 4 6.42476 22.0762 28.8013 7.623 -17.0728 6.50296 -3723 6 39.796 25.1427 32.5747 9.70804 -1.04373 -32.2987 -3724 4 39.5377 25.4516 33.4106 -12.9416 11.3784 38.6909 -3725 4 39.6539 25.9218 32.0211 1.09764 -5.16827 -8.54386 -3726 6 40.8629 21.4836 8.86543 0.741147 13.6451 -7.24725 -3727 4 40.6441 21.3431 7.92826 2.29745 -6.5969 8.98303 -3728 4 41.3236 20.7041 9.20266 3.81714 -8.25026 -3.81722 -3729 6 0.635293 1.4289 12.9408 -11.8573 10.3167 -17.0811 -3730 4 54.7874 1.76314 12.6159 9.08744 8.74788 -10.2417 -3731 4 0.270536 0.805051 13.547 10.8795 -21.9384 23.5147 -3732 6 32.6734 29.7199 23.4842 -6.31159 -22.9731 3.95312 -3733 4 32.3164 28.805 23.472 7.37478 14.3791 4.20759 -3734 4 32.5291 29.9779 22.5736 0.738758 10.2783 -10.1223 -3735 6 12.5322 37.1564 20.4866 30.6876 51.3804 29.6269 -3736 4 13.0449 37.1468 21.3313 -10.4644 -1.04639 -16.0138 -3737 4 12.1935 36.3015 20.3752 -17.5174 -49.5479 -6.43685 -3738 6 13.879 14.5208 24.6979 -2.0089 -0.488943 14.0828 -3739 4 13.5126 15.2415 24.1863 -2.86121 7.01781 -5.24136 -3740 4 14.0435 14.8889 25.5812 -0.885703 0.504049 -6.33424 -3741 6 17.5084 27.0547 26.4789 25.7109 3.2743 -38.4356 -3742 4 17.3703 27.9297 26.0618 -4.07905 -12.769 13.7294 -3743 4 18.1097 26.6273 25.8042 -17.4354 5.34049 24.3014 -3744 6 54.4807 9.52867 26.3526 -8.08409 11.5192 21.059 -3745 4 54.0543 10.3952 26.5681 7.59002 -15.9534 -5.94965 -3746 4 54.8701 9.18952 27.1901 -5.85154 7.09102 -14.0848 -3747 6 33.6811 21.5047 24.9231 9.13792 -2.03882 -43.3211 -3748 4 33.6373 21.3676 23.9235 3.71376 4.25849 32.7793 -3749 4 32.846 21.1613 25.2346 -13.4677 -6.75943 10.2286 -3750 6 22.147 35.267 2.89295 -1.50127 3.24452 17.3348 -3751 4 22.2381 34.4 2.47628 0.948748 -2.82555 0.0189077 -3752 4 22.0999 35.1233 3.8735 0.523717 -2.91888 -18.7193 -3753 6 45.3111 5.3951 15.6139 -0.0233827 -18.9082 29.3701 -3754 4 45.1442 5.22798 16.5663 9.63366 2.6406 -14.7931 -3755 4 44.5125 5.84005 15.3428 -8.81534 4.22624 -14.6387 -3756 6 5.67663 7.59044 16.9735 -0.040306 4.08799 -12.5895 -3757 4 5.28026 7.88599 16.128 7.47401 -1.2917 10.5251 -3758 4 6.58383 7.937 17.01 -0.793937 -3.87211 -2.68331 -3759 6 34.58 39.0977 27.2045 1.42769 14.436 -3.31523 -3760 4 34.2907 38.4975 27.863 -0.77861 -26.0942 16.6839 -3761 4 34.0642 39.8725 27.4397 -1.42861 13.6713 -5.6929 -3762 6 32.7657 33.6085 34.293 -22.4583 20.5671 -18.6673 -3763 4 32.1806 34.0441 33.6111 23.9751 -17.2665 15.818 -3764 4 32.4638 34.0082 35.1245 2.30326 -6.42306 -1.86009 -3765 6 30.988 41.2133 32.384 -4.02481 -7.82035 -3.95856 -3766 4 30.2267 41.2202 32.9774 -4.32902 6.50081 -0.328838 -3767 4 31.0509 0.17511 32 -1.2051 10.1503 -2.92525 -3768 6 7.6493 1.59177 27.1464 22.3535 -22.6118 -16.4669 -3769 4 8.41104 1.29664 26.5499 -29.8997 15.2665 16.3611 -3770 4 7.54328 2.53873 27.061 4.65755 9.49162 -4.22239 -3771 6 0.888965 22.101 37.8501 15.4112 -23.8094 -16.9331 -3772 4 1.26739 21.3109 37.3638 -11.0686 24.0488 15.8162 -3773 4 1.18 22.8712 37.3372 -1.61814 -2.27923 2.93708 -3774 6 7.39632 11.121 19.2332 -2.86932 4.41375 3.62624 -3775 4 7.58751 12.0436 19.3904 -7.23274 18.3647 6.41875 -3776 4 8.29083 10.7877 19.1848 5.97481 -12.1861 -3.76707 -3777 6 43.7816 12.5054 37.3126 2.86093 2.78929 -1.28281 -3778 4 43.9727 12.4749 36.3586 -3.06612 0.785718 5.83621 -3779 4 44.6572 12.6706 37.7021 -4.14278 -2.20963 -1.61523 -3780 6 29.0947 33.5132 36.1777 7.61955 17.1376 -26.1106 -3781 4 29.8261 34.0815 35.8667 -13.5031 -6.20718 4.51186 -3782 4 29.4784 33.1216 36.9462 10.9925 -12.9866 20.6523 -3783 6 14.807 4.60084 3.93512 20.0881 9.19657 -13.3363 -3784 4 14.316 4.04064 3.33426 -13.0632 -7.60853 1.79497 -3785 4 15.6236 4.79338 3.42413 -10.111 -0.253003 10.8348 -3786 6 39.0437 6.41097 6.40143 -11.952 4.4329 11.9095 -3787 4 39.4604 7.16771 6.02322 8.12547 27.0605 -0.357881 -3788 4 39.3566 5.75952 5.7919 -0.567413 -21.3616 -5.48613 -3789 6 22.2146 37.9992 40.767 -9.02066 -17.4896 -19.1754 -3790 4 22.494 38.8839 40.5618 6.85259 22.4587 -5.93601 -3791 4 22.4583 37.8811 41.6743 4.99519 -4.33654 23.0463 -3792 6 4.4524 23.286 6.15211 29.8095 -7.21279 -13.1375 -3793 4 3.81791 23.938 6.45512 -14.4589 -6.71938 9.72163 -3794 4 4.31449 22.3781 6.49744 -8.68344 13.1635 4.00749 -3795 6 12.4271 23.7748 9.24631 -1.26755 4.43152 21.3749 -3796 4 11.5607 23.6235 8.88266 -11.7175 -2.77193 -9.11925 -3797 4 12.2509 24.3149 10.0432 11.3809 -1.60307 -13.9136 -3798 6 46.4989 15.2625 16.9679 -12.8481 -2.49131 10.8408 -3799 4 47.085 14.9252 16.2779 8.49272 6.07271 -3.86524 -3800 4 46.8927 16.0486 17.3753 9.61298 -1.72862 -3.23202 -3801 6 34.1182 27.164 19.7815 17.9289 -11.392 6.58771 -3802 4 34.8637 26.5005 19.7508 -17.7467 14.3364 5.12367 -3803 4 34.0077 27.4664 20.702 3.31322 -6.80894 -12.4792 -3804 6 46.9518 13.2225 35.1059 11.5726 -0.299351 34.0182 -3805 4 47.3951 14.0533 34.9197 -1.30218 2.22738 -12.772 -3806 4 46.5273 12.8898 34.3328 -6.46075 0.0352155 -21.0879 -3807 6 50.5846 18.7905 12.5321 0.161349 -2.47544 -10.5355 -3808 4 49.7474 18.3698 12.2516 10.3296 3.30344 0.704295 -3809 4 51.1853 18.7954 11.7538 -11.6392 0.795373 7.80699 -3810 6 32.4849 12.6316 31.9547 13.623 -32.1984 -17.1952 -3811 4 32.7548 11.6805 31.9646 -3.77817 17.5545 -6.43374 -3812 4 32.3724 12.7906 32.8759 -7.39939 11.2146 27.5789 -3813 6 6.21204 19.6856 10.0139 6.84548 18.8235 13.1049 -3814 4 6.54027 20.2383 9.28123 0.761161 -1.37122 2.72757 -3815 4 6.08461 20.3138 10.7689 1.69871 -13.3343 -16.4193 -3816 6 21.5267 21.5372 2.4283 -5.72751 11.2346 -5.82425 -3817 4 21.7624 21.5115 1.48057 4.80944 -6.6677 9.03128 -3818 4 21.9699 20.8013 2.88237 1.68469 2.19074 -10.3234 -3819 6 38.389 23.0803 17.19 -15.8009 11.2489 14.8144 -3820 4 38.843 23.3405 16.3672 7.30113 -17.2523 7.40945 -3821 4 38.5581 22.1678 17.4979 8.57434 6.38113 -15.3203 -3822 6 29.7009 24.9705 22.2505 40.9979 -45.9373 -29.6811 -3823 4 30.2007 24.9541 23.0531 3.51493 7.58579 28.6285 -3824 4 28.9709 25.5198 22.3387 -45.941 40.092 17.1582 -3825 6 30.3026 21.4444 37.7784 -57.0222 17.1687 -23.3742 -3826 4 30.3615 21.3347 36.805 9.38026 -2.23221 21.4717 -3827 4 29.3011 21.6413 37.9016 49.3444 -12.8915 1.59191 -3828 6 11.8723 11.7062 16.3108 -33.4349 -15.0686 -41.1118 -3829 4 11.3207 12.2631 16.8681 -3.98396 2.02201 -1.40695 -3830 4 11.3108 11.5232 15.4705 24.8968 9.48818 41.0096 -3831 6 5.70652 16.9717 10.4705 4.17204 -12.2255 5.26049 -3832 4 4.89872 17.0293 11.0039 1.44556 1.21447 -8.81597 -3833 4 5.85075 17.8293 10.0626 -3.65007 4.58518 2.58079 -3834 6 41.6977 34.1692 35.8837 -2.16171 7.35997 35.3278 -3835 4 41.9434 35.0359 36.2767 -7.39108 -12.3774 -11.2945 -3836 4 41.6554 34.2509 34.9408 0.248654 6.88642 -24.6778 -3837 6 33.755 1.15956 30.1148 26.9661 -5.30311 0.785489 -3838 4 32.8327 1.41064 30.2749 5.35845 -2.81639 19.5818 -3839 4 34.3082 0.981132 30.9387 -30.8845 7.54253 -18.2089 -3840 6 50.3537 18.6141 36.9811 22.0078 18.2711 -1.17075 -3841 4 50.0553 18.9081 37.8421 -3.0234 4.11827 7.26126 -3842 4 49.7241 17.9789 36.6994 -26.7065 -28.1871 -12.5747 -3843 6 24.6713 24.2747 40.2422 -22.5478 13.5437 8.83718 -3844 4 23.7682 24.4281 40.6159 16.469 -5.34198 -8.29501 -3845 4 24.8078 23.3187 40.2616 -1.76472 2.5507 -0.358513 -3846 6 37.3089 22.0315 23.2412 -5.67505 16.6134 8.34505 -3847 4 36.9227 21.8066 24.1113 8.4343 -8.15598 -10.5545 -3848 4 37.8295 21.3076 22.8826 1.63944 -5.88141 4.04288 -3849 6 48.4175 40.505 28.9613 -8.44239 17.3351 -31.8351 -3850 4 48.9168 41.2502 28.5701 -3.67522 -6.90368 3.5913 -3851 4 47.6498 40.4225 28.3398 9.75729 -4.39015 14.633 -3852 6 24.8456 8.73476 16.5822 -4.20971 0.107082 12.7896 -3853 4 25.4166 9.33437 17.0882 0.801486 -3.84637 -6.6671 -3854 4 25.3552 7.93888 16.3774 1.47583 -1.66023 -1.71228 -3855 6 19.2415 22.9983 32.4591 18.0731 -7.21062 -7.32059 -3856 4 18.4972 23.4837 32.0941 -3.55414 -1.2008 3.19393 -3857 4 18.9283 22.447 33.1757 -6.31405 0.951806 3.86493 -3858 6 3.33315 21.6719 22.4471 -31.3651 -15.1442 10.7623 -3859 4 2.72119 22.0562 23.134 20.4737 -7.45649 -18.1084 -3860 4 4.09369 22.238 22.38 14.9219 12.7334 2.89238 -3861 6 10.2287 20.327 12.827 -13.2346 -13.5387 -5.73443 -3862 4 9.59835 20.9044 13.2794 3.30523 -1.6991 -3.3419 -3863 4 9.66163 19.6709 12.3619 8.96671 11.3846 7.22783 -3864 6 9.52445 0.665703 25.3447 51.6699 36.9138 -22.1471 -3865 4 10.407 0.70007 25.8038 -28.3091 -11.588 2.11711 -3866 4 9.73816 1.30323 24.5834 -23.5062 -26.9191 23.3279 -3867 6 10.6629 40.7098 9.64162 -13.7092 -10.0604 -17.7529 -3868 4 10.6663 41.3337 10.3633 -2.25222 9.44489 9.13119 -3869 4 9.9177 40.9644 9.04966 14.1089 -1.91013 12.7496 -3870 6 46.3583 25.2138 32.6818 -7.00173 28.401 24.5039 -3871 4 46.1658 26.0815 33.1748 9.63216 -40.3762 -24.4036 -3872 4 46.6683 25.4845 31.8081 -0.340565 -0.626762 -0.366217 -3873 6 38.9398 3.19835 23.1062 35.7507 -3.98021 4.80576 -3874 4 38.0789 3.42388 22.7807 -21.691 0.0477325 0.592254 -3875 4 38.9606 2.6551 23.9199 -14.9585 3.95725 -7.0779 -3876 6 33.3518 23.6324 36.8776 -10.909 11.1506 22.2396 -3877 4 32.7475 23.7189 37.6717 16.9933 -10.7727 -23.1962 -3878 4 33.5054 24.5617 36.6454 5.48307 -3.56245 -8.14833 -3879 6 51.9403 33.327 25.4307 18.0164 46.0043 -41.5452 -3880 4 51.481 33.1217 26.2288 -14.6019 -1.8433 25.1586 -3881 4 51.8744 34.3335 25.2555 2.07578 -44.1738 12.4077 -3882 6 32.1773 25.016 33.1611 -3.65323 12.5958 -4.40686 -3883 4 32.7417 25.8243 33.1248 -13.2213 -13.5953 2.20315 -3884 4 31.2567 25.3353 32.9959 15.6883 -4.24783 1.324 -3885 6 51.2804 27.7082 39.5058 -12.4055 -13.8576 13.4454 -3886 4 51.6333 27.8214 38.6405 7.56348 -1.28822 -27.9214 -3887 4 51.668 28.4332 39.9759 4.38661 13.1583 16.7532 -3888 6 34.2776 28.325 17.2612 18.5433 -9.6807 0.726105 -3889 4 33.4618 28.7621 17.0499 -21.6526 10.7978 2.5619 -3890 4 34.2928 28.1986 18.2187 -4.64072 -2.98555 4.57564 -3891 6 36.914 8.0422 37.8636 -11.4128 -16.3489 28.1347 -3892 4 37.1972 8.46051 37.0352 12.2245 9.0272 12.2411 -3893 4 37.2151 8.41454 38.7513 -7.64029 -1.69915 -40.4466 -3894 6 34.8876 19.4054 6.12727 15.6033 7.52257 2.15709 -3895 4 34.0531 18.9355 6.15655 -6.74313 -1.04378 -1.75599 -3896 4 34.6977 20.3552 6.00766 0.606543 -4.24654 -1.2187 -3897 6 52.9513 9.46866 7.83406 2.51792 52.5995 -46.1577 -3898 4 52.8182 10.1965 7.1313 21.8169 -33.4663 26.408 -3899 4 52.1097 9.49548 8.25498 -20.9439 -11.3984 23.93 -3900 6 36.2784 5.48477 38.9735 -18.6298 -4.41122 2.56352 -3901 4 36.9459 5.47799 39.6359 15.3203 -14.8264 18.8091 -3902 4 36.5882 6.23606 38.5023 -2.18903 24.2959 -30.3279 -3903 6 10.0091 14.4595 13.4727 4.14065 20.8003 14.1725 -3904 4 10.1735 15.3719 13.8184 -7.35802 -17.2864 -8.75733 -3905 4 9.20522 14.5177 12.9398 -1.57173 0.82324 -0.279823 -3906 6 17.2166 24.3595 39.7866 10.3316 -24.6644 9.74438 -3907 4 16.8461 25.2181 39.6219 -11.8102 15.8188 2.99696 -3908 4 16.9967 24.0978 40.7081 2.51259 6.67153 -9.86646 -3909 6 49.0842 32.5535 7.76087 3.66191 -12.3496 8.85055 -3910 4 48.2705 33.0417 7.89853 -4.87459 2.09702 3.01394 -3911 4 49.5463 32.9698 7.04629 8.35168 7.01386 -14.6239 -3912 6 44.8849 24.3899 5.46806 25.9844 8.68062 13.8603 -3913 4 44.662 24.5947 6.37974 6.74107 7.22813 10.7323 -3914 4 44.0754 24.0079 5.20592 -32.7636 -20.0017 -25.3594 -3915 6 37.3054 29.188 32.8461 11.1431 -5.59449 16.1726 -3916 4 36.8523 29.4202 33.6742 6.83247 1.44061 -4.51415 -3917 4 36.6742 29.3068 32.1579 -22.7291 3.94299 -14.9304 -3918 6 0.907991 24.8221 21.2346 15.0832 19.7352 -4.57067 -3919 4 1.06453 25.2816 20.3717 -1.39622 -8.03116 21.3543 -3920 4 1.45755 25.2897 21.9154 -11.7661 -11.1398 -13.6241 -3921 6 53.0192 2.206 13.0014 -0.818186 11.5483 2.08343 -3922 4 52.7824 1.81345 13.8314 -6.90556 -15.4066 8.50991 -3923 4 53.4537 3.0128 13.31 2.83183 5.68595 -7.528 -3924 6 24.3052 33.9756 13.9324 20.4312 -11.5489 10.0229 -3925 4 23.7773 33.1726 14.1229 5.8111 10.1191 -2.33499 -3926 4 25.2169 33.8698 14.327 -30.0349 3.28274 -10.0023 -3927 6 40.9302 19.2912 0.318024 -15.3988 27.4065 1.86032 -3928 4 41.1581 18.3902 0.297675 9.36546 -44.4479 -0.119704 -3929 4 41.7646 19.7516 0.396104 7.20249 9.57203 1.55489 -3930 6 38.311 32.026 21.5914 -16.5672 24.1097 -12.7773 -3931 4 37.7777 31.3762 21.1012 4.07846 0.69211 1.97712 -3932 4 37.9765 32.9287 21.3171 8.34414 -28.994 10.9395 -3933 6 42.3062 34.9979 16.9676 -25.16 18.3345 5.87282 -3934 4 41.5364 35.0784 17.5803 19.0968 -0.611651 -8.13832 -3935 4 42.7061 34.1505 17.1117 7.13758 -14.417 1.0169 -3936 6 19.559 24.3289 21.9471 -10.3882 -39.985 28.3228 -3937 4 19.0651 23.5074 22.2416 22.0177 25.9498 -5.97634 -3938 4 18.911 24.732 21.3859 -10.0006 10.9377 -12.5795 -3939 6 21.0734 3.08215 14.9508 5.66735 1.93263 4.27485 -3940 4 21.953 3.50152 15.1067 -15.9394 -6.36392 -7.95302 -3941 4 20.9814 2.87634 14.0019 2.73511 2.88399 3.27523 -3942 6 16.4416 12.1461 28.5328 0.855962 3.79198 1.54672 -3943 4 16.9672 12.6551 29.168 -2.37031 -0.949071 -4.41291 -3944 4 15.802 12.7688 28.1665 0.405815 -3.95107 1.98596 -3945 6 29.5641 4.71626 21.7415 17.492 -20.3905 -14.0863 -3946 4 29.717 3.79719 21.4198 0.937107 17.7735 8.56359 -3947 4 28.6765 4.939 21.4721 -9.06619 5.19467 -0.439365 -3948 6 47.4133 12.088 13.4013 -19.6032 -12.6622 16.1152 -3949 4 46.7677 12.2286 12.6843 7.8139 0.82382 7.69043 -3950 4 46.8958 11.6888 14.1608 19.5987 16.3505 -27.3211 -3951 6 26.4348 0.0314913 5.59163 -38.6673 11.9556 1.59378 -3952 4 25.5144 0.513751 5.59151 44.3701 -31.5426 2.21012 -3953 4 26.2832 40.9933 5.84663 -4.6239 23.4679 -5.56234 -3954 6 20.8211 34.8097 41.3598 6.97593 19.5597 16.9804 -3955 4 20.8796 35.753 41.6458 -3.00787 -20.9192 -8.75426 -3956 4 21.5767 34.358 41.784 -4.89338 4.10004 -2.4608 -3957 6 12.6876 17.479 1.38718 -1.79098 16.5747 12.6529 -3958 4 12.721 17.2085 2.3151 1.79447 -6.15344 -4.56661 -3959 4 12.6249 16.7029 0.834077 -0.882684 -12.7315 -6.97767 -3960 6 30.0809 10.1879 8.41184 2.17826 -2.71045 -21.4672 -3961 4 29.3744 10.7602 8.07412 2.70218 -2.7161 1.39802 -3962 4 29.921 10.0821 9.33998 -2.4398 0.0699553 19.6849 -3963 6 36.338 5.45526 23.9203 5.99313 10.0946 16.1749 -3964 4 36.1182 6.35936 23.6236 3.48165 -5.42435 1.21963 -3965 4 37.0503 5.55216 24.5976 -11.7354 -2.45534 -11.6386 -3966 6 34.0137 39.9398 19.5054 17.9066 -9.75089 21.0607 -3967 4 34.5988 39.5452 20.1731 -15.7075 -1.02338 -1.83906 -3968 4 34.6431 40.5289 19.082 -7.6391 9.5881 -14.1485 -3969 6 25.1112 29.0201 17.0007 35.0878 36.529 -22.1514 -3970 4 24.4917 28.3695 17.2244 -30.3786 -36.8419 16.5077 -3971 4 24.8604 29.2867 16.1023 2.15056 -2.21883 6.37313 -3972 6 28.5036 21.3308 6.52422 21.0338 -5.55128 30.7615 -3973 4 28.0688 21.6386 5.71574 5.06238 16.4658 -0.926129 -3974 4 28.989 22.0506 7.05137 -24.5794 -13.751 -30.0602 -3975 6 18.6637 26.1498 0.432001 -8.53447 25.4727 10.2843 -3976 4 18.1393 25.3713 0.533905 -9.92127 -26.6833 -5.54807 -3977 4 18.1707 26.7698 1.00478 10.6071 3.27379 -7.60185 -3978 6 10.9817 29.7047 15.4617 -41.5317 11.7513 13.4553 -3979 4 11.6879 29.3608 14.9846 35.2501 -21.9962 -32.1318 -3980 4 11.3889 29.9926 16.2601 5.02956 8.45945 23.8164 -3981 6 33.4827 3.76017 10.5773 -2.41261 -0.304069 24.838 -3982 4 33.4731 3.39919 11.5182 2.46452 11.5285 -31.0446 -3983 4 33.5847 4.73535 10.6555 -0.240223 -15.9168 2.16837 -3984 6 12.2973 28.805 23.0387 -1.70787 -5.55619 5.61474 -3985 4 12.73 29.6571 22.9381 2.67417 5.94729 -0.690524 -3986 4 11.5024 28.994 23.5653 2.03311 -0.198261 -3.05575 -3987 6 13.0915 10.291 41.0216 -35.9662 5.53295 8.52282 -3988 4 13.8386 10.0408 41.5246 29.6538 -8.48465 17.7322 -3989 4 13.4107 10.5366 40.1733 8.17866 7.18603 -23.992 -3990 6 45.8162 29.981 22.3537 -23.4909 -34.782 -9.94688 -3991 4 46.3605 30.6906 22.6479 19.8522 18.211 11.3118 -3992 4 46.1638 29.1315 22.7274 -3.04842 19.9099 -5.39144 -3993 6 41.5671 12.1372 14.78 12.0724 6.03101 -10.0784 -3994 4 40.8481 12.1001 15.4119 -11.2612 -2.38036 6.73971 -3995 4 41.9114 13.0311 14.8874 5.93112 4.19505 -0.667369 -3996 6 18.1729 7.20363 24.1739 -28.0382 48.7978 3.52623 -3997 4 17.4064 7.85498 24.128 33.406 -18.9268 -1.93395 -3998 4 17.7199 6.38321 24.1568 -14.2968 -40.16 -0.285645 -3999 6 1.47767 28.308 7.57167 -25.5616 27.2209 -25.1393 -4000 4 0.827452 27.622 7.68711 2.49251 -16.9659 6.86802 -4001 4 0.906232 29.0217 7.18328 24.331 -5.18373 6.93061 -4002 6 11.3359 12.3164 24.0718 -23.8013 37.4997 -14.7667 -4003 4 11.6691 13.0224 24.6595 3.51665 -15.1291 3.43827 -4004 4 11.6925 11.4858 24.3227 20.8697 -21.176 20.4973 -4005 6 17.9852 40.4684 24.4198 -2.05389 -13.7174 33.2687 -4006 4 18.291 40.9889 23.6947 8.79563 24.1615 -11.819 -4007 4 17.8495 41.0209 25.2243 7.13458 -7.65509 -20.9696 -4008 6 25.5964 7.43792 34.0141 13.5012 12.0052 -20.5927 -4009 4 25.8913 7.969 33.2287 -3.90825 -14.1502 17.4414 -4010 4 24.6674 7.63663 34.1466 -9.57807 0.741149 3.27376 -4011 6 16.9692 36.3856 7.79034 -41.9934 -28.8773 9.66508 -4012 4 16.1027 35.9203 7.98218 37.4859 8.56847 -14.648 -4013 4 16.8197 37.2026 8.24874 12.7807 20.325 5.07796 -4014 6 12.4125 39.1679 36.8113 4.83627 -30.6012 -9.1357 -4015 4 13.2866 39.4994 36.9682 3.20673 22.8904 8.84646 -4016 4 12.7018 38.3069 36.4569 -23.4958 5.90479 1.90955 -4017 6 23.4443 1.91649 37.7131 1.30421 0.985484 -2.89526 -4018 4 22.7028 1.66545 37.1374 7.60384 11.2995 4.79583 -4019 4 23.7753 2.79308 37.4363 -6.35903 -5.24233 -3.11404 -4020 6 26.6169 34.8556 39.068 -18.8945 24.0174 -16.1573 -4021 4 25.9011 35.0209 39.7003 9.00825 -5.11239 -0.809586 -4022 4 26.448 35.531 38.356 7.64302 -20.2436 14.8851 -4023 6 44.7566 35.572 23.174 8.53117 -4.94531 -21.3447 -4024 4 44.5551 36.3183 23.7275 -7.66893 11.3086 12.1688 -4025 4 44.9082 35.9286 22.2729 -0.906387 -11.1819 10.3159 -4026 6 34.6091 35.4265 26.6991 -7.96701 8.74937 -1.29134 -4027 4 33.7558 35.2865 27.1578 16.0802 3.93421 -4.37465 -4028 4 35.2785 35.5457 27.4013 -9.86041 -2.80018 -4.60569 -4029 6 12.4308 29.8402 9.37325 4.00701 15.5633 13.1387 -4030 4 12.6298 30.2095 10.2592 0.427445 -8.8693 -11.9579 -4031 4 11.9163 30.5385 8.94302 -0.259504 -4.09781 -0.505047 -4032 6 46.4536 41.3715 16.9585 -0.509472 -10.7221 -3.48983 -4033 4 46.3968 0.20327 17.5639 0.209317 7.43894 6.10767 -4034 4 46.3711 41.769 16.0793 0.075994 -2.20044 0.741492 -4035 6 39.1811 31.047 24.0166 -28.3946 14.7902 -31.7872 -4036 4 39.0009 31.2944 23.0615 15.0891 -8.50563 28.3067 -4037 4 38.282 31.1199 24.3765 13.6746 -2.33731 7.34059 -4038 6 40.5375 9.75603 28.9763 9.47615 -22.8392 -16.3574 -4039 4 40.717 8.78834 28.9749 -4.02124 18.0325 0.597023 -4040 4 40.0442 9.94417 29.7674 -4.45736 4.50836 13.2228 -4041 6 33.5752 11.9033 22.735 -22.7947 23.9621 15.9921 -4042 4 33.2963 12.1808 21.8555 7.18969 -8.33444 -8.87292 -4043 4 33.0376 12.5465 23.2695 22.9257 -24.0379 -3.52442 -4044 6 29.0301 38.739 2.44557 13.7604 -11.9544 -20.6568 -4045 4 29.2066 39.6607 2.23242 1.09325 2.62923 1.14408 -4046 4 28.4566 38.7797 3.20164 -8.68487 1.4276 10.4377 -4047 6 51.2789 6.14828 28.303 0.614736 -0.570337 1.8431 -4048 4 51.6973 5.27456 28.1665 -1.53436 11.093 -0.261734 -4049 4 51.6265 6.73477 27.6091 2.17001 -12.1019 4.10374 -4050 6 34.1129 16.6124 14.0322 -32.0491 -20.8609 -4.49638 -4051 4 33.8537 17.5241 13.9801 -4.99199 17.3104 -1.82528 -4052 4 35.0495 16.5739 14.0336 36.3732 5.94549 -0.19423 -4053 6 34.4398 40.0505 7.51971 -1.5967 1.86622 -34.5907 -4054 4 34.4907 40.736 6.82898 6.47702 11.7366 29.0204 -4055 4 34.1466 39.3906 6.89306 -3.09667 -23.6565 15.965 -4056 6 42.5416 22.9885 4.36731 16.709 1.02816 -9.65968 -4057 4 42.6773 23.0677 3.40021 -12.3994 2.37358 9.8727 -4058 4 41.6332 23.2481 4.59133 5.34809 1.54884 -5.45539 -4059 6 1.43335 11.7249 10.5915 17.9648 34.7983 -1.93775 -4060 4 2.18855 11.6351 9.93392 -25.2532 9.63542 18.7746 -4061 4 1.3761 12.7012 10.8984 13.7257 -41.7135 -20.7702 -4062 6 10.0197 17.1509 40.4023 -3.34945 -21.541 12.0793 -4063 4 9.07741 16.8499 40.449 26.596 5.40866 2.75879 -4064 4 10.6028 16.482 40.874 -24.6204 18.7768 -14.392 -4065 6 26.3793 1.16939 23.7984 9.5834 26.112 -20.0106 -4066 4 26.3482 1.63114 22.915 -1.08564 -15.7005 23.7132 -4067 4 26.8817 1.81632 24.3342 -3.35925 -10.5223 -0.68284 -4068 6 4.47487 16.2271 39.0058 33.4959 -10.553 -10.6989 -4069 4 4.63618 15.8937 38.0801 -2.33968 7.70086 24.4633 -4070 4 5.35244 16.1813 39.5129 -32.5033 1.65679 -19.7071 -4071 6 24.3835 39.8482 14.0852 2.84697 7.18038 -0.286146 -4072 4 24.1877 40.6985 13.6429 5.77715 -11.144 2.19115 -4073 4 25.1234 39.4426 13.6288 0.754333 1.29636 -3.16103 -4074 6 19.9701 19.0136 10.1131 -5.22385 -12.8057 23.8822 -4075 4 19.1001 19.3633 10.3498 -0.643873 5.13605 -7.14836 -4076 4 20.1315 18.3631 10.8504 3.64009 16.176 -24.2707 -4077 6 45.2329 15.0638 25.3099 -19.5547 20.2245 12.2671 -4078 4 44.4482 15.622 25.4263 4.62838 7.04728 2.57625 -4079 4 44.8851 14.3824 24.752 0.155489 -22.5403 -14.0061 -4080 6 47.6439 32.9533 29.9771 4.38746 -1.69347 6.40492 -4081 4 47.8622 32.5347 30.8309 -5.05982 6.77924 -7.14273 -4082 4 46.6855 33.0215 29.8843 -3.06966 -4.44082 4.14054 -4083 6 9.30872 14.1631 35.6268 19.7088 14.7601 29.7215 -4084 4 10.221 13.8687 35.4779 -5.99131 -8.3331 -9.89462 -4085 4 9.36538 14.5282 36.5395 -10.4264 -5.45721 -18.9107 -4086 6 0.534978 28.7509 32.1461 -15.0727 14.1973 -4.1115 -4087 4 0.468283 29.1163 31.2513 -2.72678 6.96628 5.64212 -4088 4 0.834469 27.866 31.9601 7.81775 -11.1437 7.49829 -4089 6 26.1375 14.1816 40.8286 20.1166 -40.7048 30.4826 -4090 4 26.3241 13.5573 41.5993 3.0023 20.8863 -27.3959 -4091 4 25.2151 14.3343 40.9319 -22.5068 13.4131 -3.44564 -4092 6 38.0468 1.72227 37.358 -19.6589 11.4537 -4.22791 -4093 4 38.2764 1.77906 36.4154 -1.14244 -2.14966 7.97792 -4094 4 37.182 2.20858 37.4052 20.9639 -13.8426 2.93072 -4095 6 43.3928 21.0193 0.385094 -33.4221 -4.11839 13.5226 -4096 4 43.2305 21.8771 0.864972 20.5484 -13.2955 -16.2126 -4097 4 44.243 20.9573 41.8451 7.78799 18.4844 3.58779 -4098 6 29.7343 12.3918 17.0888 -10.4088 14.6249 -44.7733 -4099 4 30.3573 13.1084 17.3121 -1.69191 -12.5137 15.8564 -4100 4 29.5365 11.7717 17.7855 9.28071 1.18848 24.195 -4101 6 21.0845 11.002 35.643 19.2467 11.9534 29.728 -4102 4 20.8387 11.9292 35.5336 -5.23529 -0.657509 -1.91086 -4103 4 20.6782 10.509 34.9529 -15.7216 -13.7754 -25.5995 -4104 6 24.3584 22.1274 17.054 -19.116 4.6391 -13.6617 -4105 4 24.8062 22.8618 16.6504 0.246813 15.5697 -7.02352 -4106 4 25.0581 21.6899 17.4914 19.3443 -19.237 19.9016 -4107 6 44.2632 9.62803 6.15095 12.4515 -7.11379 4.41615 -4108 4 44.6939 9.46248 5.31272 4.1824 -3.3463 -6.13814 -4109 4 43.3875 9.94101 5.94426 -13.441 6.05535 2.74078 -4110 6 40.7983 2.89203 6.29118 6.30341 -5.06299 2.94692 -4111 4 40.283 3.08384 7.0886 -2.93464 8.08246 -11.2803 -4112 4 40.6425 3.53992 5.58152 -5.48248 3.30556 7.46891 -4113 6 23.4927 29.787 25.2074 -17.9847 -14.6764 23.1638 -4114 4 22.9663 29.9524 24.4255 0.505661 2.84572 -7.25135 -4115 4 24.3189 30.243 25.1366 19.4862 15.0746 -12.06 -4116 6 45.2253 20.6067 7.48804 -4.5495 -5.9569 -0.737791 -4117 4 44.4771 20.6075 6.85512 7.98227 -4.73543 5.3389 -4118 4 45.4897 19.6858 7.65762 -3.7219 7.49041 -4.48952 -4119 6 44.1869 26.5802 16.6604 -2.53584 -23.4697 22.3036 -4120 4 44.4278 26.4187 15.7655 11.491 9.41288 -34.0672 -4121 4 43.9629 25.6676 16.9 -3.51956 3.82806 13.7521 -4122 6 23.5847 27.0608 18.0875 4.92857 -1.63386 -8.1099 -4123 4 23.1417 26.2886 17.6568 -1.85204 16.5134 12.3838 -4124 4 22.9956 27.5067 18.7318 1.2523 -15.787 -12.8337 -4125 6 45.1423 16.1006 8.91925 -12.5826 4.07054 -12.5551 -4126 4 44.1756 16.0018 8.7625 13.8686 2.25455 7.61002 -4127 4 45.2849 15.9649 9.86163 -1.87368 -3.25302 7.37304 -4128 6 39.0195 15.168 5.20911 22.9796 -5.95468 -13.3261 -4129 4 39.8169 15.5451 4.76197 -16.8333 -0.501818 4.44847 -4130 4 38.2997 15.7872 5.12886 -6.79784 14.0419 -3.1922 -4131 6 40.4728 4.77172 20.098 -25.5728 -7.96759 5.38455 -4132 4 41.2852 4.73631 19.62 25.1414 0.345713 -9.53623 -4133 4 40.6586 5.20983 20.9254 2.90807 4.2574 9.49937 -4134 6 35.8334 28.4358 39.8978 -29.6544 -30.7382 0.627816 -4135 4 35.064 27.7738 39.8775 30.8234 30.4338 1.60118 -4136 4 36.4992 28.0138 39.3349 2.0747 -0.608826 -0.916217 -4137 6 26.5626 3.56604 2.67563 -12.8067 -1.70274 -2.52813 -4138 4 26.0244 3.493 1.8476 6.72613 8.7381 24.6483 -4139 4 26.0719 4.09981 3.36162 5.66066 -13.1585 -23.5937 -4140 6 2.95645 21.6514 17.6824 -3.82104 6.40043 0.291571 -4141 4 2.91294 22.1823 18.4797 -6.37673 0.600795 10.7096 -4142 4 3.68258 22.033 17.1814 1.62588 2.51689 -6.09233 -4143 6 12.886 25.0591 25.9256 19.9254 19.7817 -8.37483 -4144 4 13.3104 25.904 25.618 -13.2675 -16.998 3.60223 -4145 4 12.0452 24.9678 25.4656 -4.65807 1.85418 -5.64346 -4146 6 41.5793 20.6554 14.1751 9.92193 3.46069 0.25892 -4147 4 42.3122 20.2044 13.7523 0.767115 -12.7084 -7.64783 -4148 4 41.9959 21.4893 14.4245 -8.84771 2.34114 1.73285 -4149 6 1.24495 39.6039 11.5378 16.0363 -42.6363 3.17437 -4150 4 1.64626 38.7705 11.134 -18.3255 36.4754 4.46196 -4151 4 1.41802 39.4632 12.4909 -5.9615 12.3362 -8.98123 -4152 6 16.0218 39.0109 34.0619 -0.331369 12.6721 -5.4452 -4153 4 15.5475 38.1996 33.7806 5.75571 19.7523 -4.5346 -4154 4 15.9899 39.7855 33.4251 -7.29137 -28.599 9.21448 -4155 6 20.567 7.02475 25.5588 2.3848 7.82756 -0.6535 -4156 4 20.909 7.86076 25.1782 -7.45606 -9.2474 3.61042 -4157 4 19.6275 6.99553 25.3185 5.42042 5.25175 -3.5088 -4158 6 45.1928 25.5902 39.1787 -21.925 2.17874 18.9559 -4159 4 45.8631 26.0435 38.6892 20.8233 13.1115 -15.3132 -4160 4 45.3324 24.6675 39.0115 4.42968 -17.7425 -2.36405 -4161 6 19.9342 40.1138 28.2835 12.5964 -14.0671 -7.25792 -4162 4 19.0067 40.1593 28.0096 1.46425 5.68018 7.52545 -4163 4 20.128 40.8224 28.917 -7.48392 0.334406 -3.99949 -4164 6 26.4878 14.2069 27.3684 6.98603 -7.23951 -28.1548 -4165 4 25.5412 14.1932 27.2537 -20.7302 0.754551 -2.34698 -4166 4 26.606 14.4537 28.2745 0.836708 4.29804 26.5652 -4167 6 51.3489 25.9487 3.45136 10.7849 20.7191 -13.686 -4168 4 51.0453 25.2386 4.01334 -1.8549 -15.8565 1.21982 -4169 4 51.853 25.5737 2.69356 -6.32678 0.0553236 13.0587 -4170 6 20.1633 26.1247 2.67289 8.83438 -16.1267 5.68002 -4171 4 20.5345 25.2411 2.88723 -1.43181 13.9101 -1.64203 -4172 4 19.9438 26.1088 1.72974 -0.778515 0.427063 3.21599 -4173 6 3.13549 11.9681 27.2232 16.3616 22.3682 9.86323 -4174 4 2.68005 12.663 26.7181 4.92926 -3.58697 -0.471129 -4175 4 3.70389 12.4466 27.8862 -15.0224 -10.9098 -14.9284 -4176 6 30.1793 26.3687 4.00051 28.7119 -30.2966 58.1206 -4177 4 30.7801 25.8341 3.46925 -1.584 2.83444 -17.1702 -4178 4 29.6371 26.9341 3.51662 -25.563 30.6813 -37.7958 -4179 6 19.3205 20.6733 30.5441 -31.721 -6.25106 8.6959 -4180 4 19.1895 21.5008 31.0287 11.509 1.10551 -1.6952 -4181 4 20.2026 20.5869 30.2 22.6938 9.52703 -0.947482 -4182 6 13.5381 36.2475 0.344803 0.685356 24.2985 -17.2657 -4183 4 13.9232 37.1122 0.0997808 14.0363 -10.2996 17.9143 -4184 4 12.867 36.2368 41.5779 -17.3214 -19.7281 -1.62589 -4185 6 13.6931 21.7661 35.9637 -11.3229 -11.9655 -19.5688 -4186 4 13.4645 21.416 35.0694 1.68887 6.71419 14.5774 -4187 4 14.5559 22.1488 35.8465 12.3178 6.48213 0.887249 -4188 6 39.4176 1.76287 25.342 34.0854 -16.9064 9.57103 -4189 4 40.0026 2.33061 25.8435 -14.6367 28.4588 7.32056 -4190 4 40.0689 1.04185 25.2643 -19.5027 -7.65211 -10.5764 -4191 6 18.2964 6.13492 35.8264 -1.82227 -5.92686 -23.3299 -4192 4 18.1639 5.26767 36.254 2.04199 12.8657 6.45456 -4193 4 18.4232 6.85005 36.4651 0.375802 -9.94466 7.47089 -4194 6 2.53148 24.639 10.0969 -49.4669 34.6161 -0.50772 -4195 4 3.3243 24.1433 10.0889 43.7683 -7.59463 9.24933 -4196 4 2.65209 25.5465 10.4987 14.0059 -27.2835 -7.72375 -4197 6 35.8204 9.94567 1.34298 17.6587 14.9905 11.506 -4198 4 36.311 10.4135 0.64327 -4.10869 -3.12473 7.53129 -4199 4 36.1923 10.315 2.19711 -13.0886 -16.0695 -26.9686 -4200 6 29.0171 17.933 41.5847 -7.4648 10.4738 41.1296 -4201 4 28.4325 17.2741 41.1888 4.90819 -0.226834 -17.309 -4202 4 29.634 18.3354 40.9804 6.59061 1.40283 -25.0927 -4203 6 46.0097 27.0807 25.8707 -17.7195 2.90801 -6.40423 -4204 4 46.7639 26.9189 26.4445 5.86789 -6.79057 7.62258 -4205 4 45.3727 26.3443 25.9794 8.73043 2.74283 1.98831 -4206 6 28.1087 10.6569 35.9055 -15.3417 -26.5964 -30.9314 -4207 4 27.3182 11.0018 35.4375 11.5227 2.30745 10.116 -4208 4 28.4572 11.2922 36.5111 4.26863 23.9808 15.1461 -4209 6 25.95 20.1976 24.7821 3.31321 9.63686 -4.79579 -4210 4 26.7637 20.7132 24.6155 -9.40037 -7.04512 10.7501 -4211 4 25.7749 20.1865 25.7378 6.19451 4.49283 1.81458 -4212 6 32.2481 30.2487 10.2005 -0.567171 -33.888 25.4585 -4213 4 32.5217 30.8918 9.54162 14.407 -2.03846 -6.18424 -4214 4 32.9483 29.5597 10.4163 -8.30199 27.6945 -16.8968 -4215 6 5.04696 34.3919 23.8165 18.9071 9.10073 -2.65681 -4216 4 5.8517 34.9395 23.7378 -5.43375 -12.4066 7.00495 -4217 4 4.47737 34.8578 23.2154 -15.6684 -1.23826 -5.97721 -4218 6 29.6446 34.9396 23.1073 8.37026 13.2143 1.46186 -4219 4 30.146 35.227 23.8877 -4.79805 -2.96005 -2.8646 -4220 4 29.6355 33.9874 23.1398 -0.169507 -13.2925 4.62646 -4221 6 52.2021 25.2197 36.2484 0.203165 -13.9358 18.8619 -4222 4 51.9199 25.3821 37.1814 5.20177 -0.668093 -22.6011 -4223 4 52.2823 24.2449 36.2046 0.468647 8.20491 -0.432122 -4224 6 6.9564 41.2598 14.9786 17.963 -12.3423 -19.5336 -4225 4 7.05881 41.0384 15.8913 -5.14113 -1.34859 16.0369 -4226 4 7.66895 40.7276 14.5577 -14.5347 12.9973 2.09466 -4227 6 27.6566 39.1405 4.67566 -15.1179 -12.1251 22.0677 -4228 4 26.8424 38.6352 4.89635 10.0979 9.09612 -9.05456 -4229 4 28.2356 39.0161 5.44259 -0.0995191 -2.46215 -4.35417 -4230 6 44.4488 15.8848 30.3925 -17.4686 4.63448 -32.2897 -4231 4 43.6243 16.41 30.3099 13.0937 -10.0294 9.08699 -4232 4 44.649 15.6212 29.457 1.77951 4.94888 23.2191 -4233 6 27.3024 38.1054 13.0907 0.224949 -17.5042 -4.12929 -4234 4 27.6483 37.328 12.5833 -5.61487 10.2238 13.6353 -4235 4 27.1416 37.8221 14.0243 3.20236 0.189733 -16.1751 -4236 6 26.6663 32.9851 36.8362 -23.8807 -10.2072 10.655 -4237 4 27.4028 33.4987 36.5569 24.2269 11.6336 -10.1628 -4238 4 26.2735 33.5165 37.5295 -1.35435 2.25064 8.62378 -4239 6 26.3226 28.1988 31.7158 32.4613 11.5871 5.04411 -4240 4 26.7492 28.3346 30.8217 -6.54697 -0.873531 32.5908 -4241 4 26.9302 28.5068 32.4691 -17.7353 -8.90623 -33.5497 -4242 6 49.2114 35.7792 23.3295 1.46842 19.8344 9.76806 -4243 4 49.8184 36.2235 23.9243 -3.28067 3.63886 4.6357 -4244 4 49.746 35.0988 22.9506 10.5329 -22.9043 -16.5919 -4245 6 44.2369 15.3613 33.5367 -0.695853 -9.37614 14.4104 -4246 4 44.9539 15.1613 32.9326 3.59625 1.2978 -8.28609 -4247 4 43.6189 15.9562 33.0977 0.720121 5.36694 -8.04858 -4248 6 16.6517 35.2697 14.032 -14.9609 -5.91625 -15.8105 -4249 4 16.8478 36.086 14.4923 5.97715 10.4369 8.21626 -4250 4 15.7311 35.3947 13.7134 15.021 -1.16653 5.16189 -4251 6 45.2991 21.4701 12.0564 -47.5016 11.1637 19.3857 -4252 4 45.9844 21.105 11.5386 20.9258 -26.0087 -22.2564 -4253 4 44.5936 20.7913 12.2178 25.8967 12.3347 -6.55717 -4254 6 51.6438 5.33792 20.1099 7.42219 12.4384 36.9688 -4255 4 51.7517 5.79258 20.9932 -2.42789 -17.2577 -23.3969 -4256 4 50.9203 5.81642 19.7 -6.55397 4.36408 -6.3714 -4257 6 22.6153 27.305 0.955308 -12.5158 1.22245 6.52354 -4258 4 21.8819 27.8542 1.31405 9.62632 -7.19502 -8.89748 -4259 4 23.0385 27.8458 0.276527 0.370713 4.24399 -0.0338259 -4260 6 46.8868 12.1467 22.3289 10.3551 9.03073 -1.70047 -4261 4 46.473 12.5446 21.5671 -2.12653 7.07083 -14.4911 -4262 4 46.1639 11.6922 22.7348 -15.0603 -15.1984 17.3736 -4263 6 33.7555 5.60359 25.2366 8.41588 -11.9289 0.48427 -4264 4 34.4013 5.10188 24.7086 -2.4022 4.68399 3.96997 -4265 4 33.0757 5.86414 24.6127 -5.93503 4.46215 -0.558809 -4266 6 44.2476 18.1243 27.2334 30.0322 17.9475 -5.65933 -4267 4 44.0927 18.7931 26.5253 0.465456 -9.97561 17.2792 -4268 4 45.207 18.2464 27.4768 -29.0014 -6.50023 -5.41996 -4269 6 5.27814 37.006 29.0846 -42.995 37.8911 -11.235 -4270 4 4.83357 37.8684 28.7516 22.264 -36.721 16.075 -4271 4 6.19253 37.2033 29.2507 20.6764 5.54169 3.86921 -4272 6 20.033 5.01392 38.9409 6.34377 -32.2179 -4.45843 -4273 4 19.8009 5.56625 39.6765 -4.47316 13.7366 14.9565 -4274 4 20.2948 4.14306 39.3359 -6.8578 18.535 -7.22498 -4275 6 17.9112 2.77214 33.8677 -16.6976 6.01838 23.4157 -4276 4 18.6113 3.34266 33.5322 6.18073 5.31505 -2.96417 -4277 4 17.3526 3.28629 34.5246 17.6921 -17.568 -20.3177 -4278 6 5.56788 23.3774 22.3326 -7.55986 13.5725 18.1102 -4279 4 6.25354 23.3408 21.6412 1.32241 8.57002 8.68476 -4280 4 5.72116 24.1623 22.9232 3.31135 -14.4794 -19.5174 -4281 6 12.7438 28.0244 40.0809 14.6998 26.4392 -25.8726 -4282 4 12.8099 29.0023 40.1455 -0.120572 -14.3051 2.54846 -4283 4 13.1526 27.8611 39.1965 -9.74214 -4.86635 20.6942 -4284 6 50.5283 38.8014 28.4207 -10.7676 14.1923 -1.71082 -4285 4 51.0354 39.5212 28.0559 20.7423 0.788408 -10.014 -4286 4 49.7626 39.3052 28.7255 -7.2831 -13.6434 5.52883 -4287 6 33.5501 8.21498 17.8605 -32.9279 -35.4008 39.405 -4288 4 33.9027 8.87262 17.3189 24.9798 40.0041 -36.6225 -4289 4 33.9074 7.37462 17.5752 8.43731 -7.27798 -4.46199 -4290 6 34.6457 34.7004 17.7764 -12.4293 -15.9601 -10.9704 -4291 4 35.1223 35.3606 18.2944 6.48769 -0.751965 0.253856 -4292 4 35.2388 33.9528 17.5616 -1.14344 9.31979 5.2604 -4293 6 40.7233 5.29016 23.4005 8.26322 -6.33781 10.3585 -4294 4 41.4774 4.87923 23.8731 -9.49225 7.91527 -13.3731 -4295 4 40.0307 4.6112 23.3711 2.34129 5.18948 -0.0201455 -4296 6 16.9127 27.7621 14.4682 52.6044 -4.68653 -2.89351 -4297 4 16.0711 28.1345 14.4444 -59.8378 16.6137 -1.60006 -4298 4 17.4608 28.5627 14.561 1.7801 -9.46587 0.070581 -4299 6 29.0363 14.6633 5.00698 9.76413 -9.29226 13.7719 -4300 4 29.5096 13.8001 4.93115 -9.10936 16.1071 1.03458 -4301 4 28.802 14.7746 5.95339 2.50956 -1.40994 -14.9204 -4302 6 36.8445 17.7203 5.07362 13.6951 -24.032 -28.6565 -4303 4 36.3003 18.4061 5.45056 -9.17068 14.5835 0.43155 -4304 4 36.9783 17.8862 4.10178 -4.81067 2.65881 25.6667 -4305 6 27.7152 25.5071 34.8558 20.6182 -10.3116 10.9196 -4306 4 28.4128 25.1948 35.4689 -8.51497 -1.72528 -14.7569 -4307 4 27.3626 26.2325 35.3632 -10.8781 12.0961 2.58089 -4308 6 24.7577 17.2803 18.064 -3.70908 -2.75228 5.17573 -4309 4 25.2464 17.9619 18.5343 4.21458 5.85634 1.04617 -4310 4 24.0216 17.073 18.6635 3.98676 -0.349172 -5.54229 -4311 6 30.1887 1.57939 5.82314 -15.3902 21.7461 -57.8894 -4312 4 29.5204 1.81013 6.46928 0.301846 -2.58557 7.21893 -4313 4 29.8355 2.03332 4.95505 20.4457 -28.7719 49.9963 -4314 6 37.4518 25.9014 8.44867 -40.4019 -33.5071 29.4213 -4315 4 38.3881 25.8301 8.67833 5.27698 -2.9507 2.74989 -4316 4 36.9261 25.2192 9.0364 31.48 35.4073 -33.2345 -4317 6 24.7717 7.01585 2.25321 22.1725 6.13312 -2.42992 -4318 4 25.3573 6.36243 2.67285 -8.4103 6.94319 2.38151 -4319 4 23.8861 6.6751 2.35128 -10.8992 -4.25211 1.65182 -4320 6 25.7992 38.8457 10.7505 7.22571 37.8744 -16.0906 -4321 4 26.2906 38.615 11.5103 14.31 -23.6918 34.358 -4322 4 26.1189 39.766 10.6411 -14.7913 -5.88601 -10.6141 -4323 6 0.557249 13.5851 28.1314 4.10373 25.7622 10.4527 -4324 4 0.335523 12.7734 27.7191 -4.86664 -22.4284 -15.6315 -4325 4 0.332586 13.4422 29.0593 -0.0574933 0.663208 0.855409 -4326 6 20.4027 17.1068 12.0342 -11.148 -26.8285 -23.5414 -4327 4 20.2541 17.2545 12.9674 -4.18463 -1.09026 14.619 -4328 4 19.9228 16.2663 11.7843 12.058 20.2306 8.20324 -4329 6 30.9875 7.38585 16.6706 43.1327 18.1844 -1.13431 -4330 4 31.2844 7.10043 15.7746 -9.95685 2.73348 15.1831 -4331 4 31.8198 7.8213 17.056 -34.7561 -19.1709 -8.28734 -4332 6 10.1956 5.78615 12.1691 19.1166 9.414 40.461 -4333 4 10.1305 6.30649 11.4071 -1.6074 30.0602 -42.5686 -4334 4 9.61456 5.08708 11.9844 -30.6818 -38.1141 -6.43609 -4335 6 18.4382 31.3444 24.1606 1.21336 -6.12525 2.83497 -4336 4 18.3965 30.3858 24.3134 -0.788465 1.61506 0.642095 -4337 4 18.2608 31.7571 25.0112 -0.825834 1.26386 0.0223154 -4338 6 27.8905 29.2615 29.2809 39.8074 15.5588 -29.008 -4339 4 28.4007 29.5348 28.4528 -32.3375 -5.53357 22.8869 -4340 4 28.6323 28.9656 29.8273 -8.8667 -4.73078 13.1255 -4341 6 38.3648 15.4483 29.7818 29.0993 -31.9427 29.9284 -4342 4 38.2401 14.49 30.0972 1.05022 38.774 -16.5136 -4343 4 39.2299 15.7257 30.2111 -34.0699 1.82394 -15.2271 -4344 6 21.7074 34.7851 5.58078 8.19375 -39.9271 5.99876 -4345 4 21.4944 33.8203 5.80476 0.548141 38.153 -5.97617 -4346 4 20.9458 35.3238 5.82701 -5.25279 -7.50871 2.73382 -4347 6 18.2117 16.8293 1.01571 -12.7233 9.06437 9.63769 -4348 4 17.5846 17.1799 0.363518 5.67247 -6.87112 -0.25098 -4349 4 17.8106 17.1001 1.86952 7.78128 -5.5379 -6.7416 -4350 6 43.5131 18.5098 39.3469 22.8992 -24.809 -24.744 -4351 4 42.9473 19.1501 39.756 -14.025 22.4758 -1.21679 -4352 4 43.733 18.7829 38.41 -14.2449 3.90475 27.8798 -4353 6 17.7973 10.0724 35.5497 11.3899 1.25644 -17.5776 -4354 4 17.9076 9.35875 36.1674 -1.9111 -9.85084 12.7139 -4355 4 18.4727 9.8826 34.8661 -11.1758 5.45367 7.50841 -4356 6 36.5836 30.5676 29.0795 -26.735 36.4018 -15.4516 -4357 4 36.5101 31.4618 28.6208 1.83791 -30.0083 14.6126 -4358 4 37.4767 30.2665 28.9506 20.8385 -5.81304 -4.31186 -4359 6 38.5024 35.9654 10.4302 15.5283 7.61871 55.4477 -4360 4 38.713 36.6589 11.1463 -7.3207 -22.805 -33.4203 -4361 4 38.3781 35.1576 10.9824 1.19538 10.4075 -12.7486 -4362 6 43.3976 18.7941 34.3717 -4.38817 -12.2014 30.3889 -4363 4 43.0627 18.1963 33.6763 0.988603 1.53223 14.3474 -4364 4 43.2603 18.4022 35.293 0.0857578 9.32555 -37.8245 -4365 6 11.0576 40.22 6.11206 -6.0837 -9.04747 -4.15047 -4366 4 11.6426 40.8981 6.46389 1.08734 7.77423 2.35531 -4367 4 10.1474 40.5638 6.06331 9.30243 4.06404 0.87098 -4368 6 48.3282 13.7431 24.4718 -8.87905 25.3224 16.0087 -4369 4 47.8536 13.4091 23.7195 -8.5266 -8.47545 -16.9724 -4370 4 47.8942 14.6072 24.6749 14.3726 -19.4181 -2.72093 -4371 6 1.47819 25.7805 23.7819 -0.0731812 -13.4431 -3.72387 -4372 4 0.822875 26.4404 23.4927 11.4147 5.84295 7.97453 -4373 4 2.19403 26.202 24.2849 -5.19934 9.21725 -1.17005 -4374 6 20.5754 0.0393205 21.1081 25.6075 5.05031 -17.3956 -4375 4 19.8484 0.361847 21.622 -17.4675 -5.38456 12.9096 -4376 4 20.5586 40.9849 21.0455 -11.1839 1.66381 7.6849 -4377 6 37.6642 12.8991 30.7037 -9.9457 -20.8438 -29.8221 -4378 4 37.1371 12.462 29.9889 18.2914 6.1257 8.16018 -4379 4 36.9745 13.1334 31.2979 -14.5618 11.4049 21.409 -4380 6 49.47 17.3794 9.25364 5.30826 8.19981 -9.14457 -4381 4 48.5231 17.6061 9.31556 15.6584 -1.48937 -5.70503 -4382 4 49.8852 17.9254 8.53549 -14.9109 -12.0851 17.4703 -4383 6 34.3662 5.35535 17.144 13.1974 2.57034 -29.0571 -4384 4 34.5198 5.2998 16.166 0.54303 4.43319 20.4174 -4385 4 33.4623 5.07036 17.243 -16.3394 -6.24992 8.38082 -4386 6 14.7833 27.6665 0.0728061 -6.74966 -7.64198 -7.69033 -4387 4 13.9925 27.8402 41.4242 12.1928 3.48747 9.75107 -4388 4 15.1668 28.5017 0.401621 -7.96817 -0.0208253 -5.02821 -4389 6 48.8656 15.5206 20.7458 -9.86138 0.136748 20.6241 -4390 4 49.0651 16.3952 20.4263 0.209458 6.72405 -7.85333 -4391 4 49.1204 14.8922 20.0789 6.79298 -9.16117 -16.8166 -4392 6 23.807 40.3882 20.3905 -3.398 23.5063 24.1729 -4393 4 23.5208 41.0259 21.1064 9.42377 -19.8715 -22.5683 -4394 4 24.7282 40.1652 20.6096 -6.91059 4.34471 -3.10789 -4395 6 35.1847 31.5046 13.7021 -31.0181 23.9456 -35.1619 -4396 4 34.2309 31.3725 13.4471 24.927 2.88592 7.27171 -4397 4 35.3946 30.8036 14.2945 4.95161 -20.634 19.3451 -4398 6 10.9658 9.01332 39.5058 -15.2714 21.9147 -18.395 -4399 4 10.5965 9.92979 39.4 9.97221 -25.6919 2.69722 -4400 4 11.1763 8.90125 40.4322 -2.36933 4.41176 3.08643 -4401 6 53.2091 4.88966 16.6226 -14.1926 -12.3632 -40.3028 -4402 4 53.7513 5.3458 17.242 7.58091 5.46958 35.753 -4403 4 52.4727 4.38631 17.0042 6.19997 4.37068 9.30068 -4404 6 7.84194 33.803 26.1542 28.433 15.6582 -32.2535 -4405 4 7.6241 34.0763 27.0539 6.31302 8.01731 -0.629847 -4406 4 8.43319 34.4994 25.6777 -29.4311 -29.3345 32.8186 -4407 6 31.3263 27.9445 6.27534 4.23256 -31.0286 -11.1959 -4408 4 31.9071 27.4889 6.92578 -8.71467 11.4818 -6.48617 -4409 4 31.157 27.2952 5.54778 3.06851 13.2477 11.4148 -4410 6 31.3665 2.16522 41.0549 8.67281 8.84877 18.675 -4411 4 31.764 2.22522 0.0553479 -13.0589 -8.62932 -24.7178 -4412 4 31.1679 1.24258 40.8683 -0.324156 -6.15668 4.61941 -4413 6 33.7659 4.25511 35.8987 -17.0312 -3.82062 1.06926 -4414 4 34.343 3.86214 36.5812 -9.75418 2.24627 -3.55813 -4415 4 32.8029 4.08293 36.1352 33.1171 1.27305 -1.46623 -4416 6 47.9658 16.0637 29.8469 2.67107 -7.93457 21.4822 -4417 4 48.7643 16.2814 30.3583 0.589987 0.219824 -12.8585 -4418 4 47.4335 15.6159 30.5321 -1.60863 4.8928 -15.0046 -4419 6 49.3312 10.0914 28.5924 -0.28152 -2.80953 -5.35856 -4420 4 48.5695 10.6519 28.8218 4.15282 -2.34898 -5.74021 -4421 4 49.4995 10.1231 27.6243 -2.44246 2.9592 14.5426 -4422 6 21.4058 27.7857 29.7524 8.26148 -8.5709 13.934 -4423 4 21.8935 27.2574 30.4222 -7.07544 0.199766 -18.4014 -4424 4 21.2999 28.6278 30.1835 -3.48366 18.9655 1.67033 -4425 6 11.6744 39.4982 25.8468 7.90293 7.18169 -2.58674 -4426 4 12.2285 38.7361 26.0681 1.40058 3.92388 1.36909 -4427 4 10.8023 39.1241 25.7384 -12.6269 0.672841 -0.990747 -4428 6 22.9696 39.3076 7.85132 -6.07512 -3.4122 -1.68244 -4429 4 22.2682 38.6524 7.98148 0.173976 5.86283 1.52023 -4430 4 22.7132 40.0561 8.41581 1.67877 -3.24138 -2.90234 -4431 6 42.551 35.9177 31.3369 11.821 -63.1978 11.5341 -4432 4 42.5803 35.466 30.4647 -4.4966 22.226 11.3725 -4433 4 42.4036 36.8376 31.2573 -6.84366 36.9754 -14.9488 -4434 6 33.6582 14.7374 3.97797 20.0935 -7.17859 -40.4554 -4435 4 32.8645 15.2412 4.10613 -20.5582 11.3796 6.05129 -4436 4 33.8494 14.8388 2.99484 -4.26498 -3.76663 30.6135 -4437 6 36.6985 8.59579 17.521 17.5186 -20.4505 -17.8166 -4438 4 37.2174 8.05238 16.87 -10.1577 15.2162 18.3492 -4439 4 36.2061 9.2161 16.9727 -6.85471 3.87096 1.58869 -4440 6 20.8134 32.4132 17.3224 -0.15138 -19.2041 8.32641 -4441 4 20.2101 33.0681 16.9297 -8.31182 -6.81981 10.9196 -4442 4 20.3788 31.7527 17.9441 5.10322 26.2393 -19.6477 -4443 6 20.7088 35.3183 14.0957 -11.7768 -25.3725 -13.8548 -4444 4 21.261 35.5893 13.3574 6.77827 9.37653 -4.07387 -4445 4 20.8679 35.9028 14.8214 6.04206 13.2639 9.85712 -4446 6 20.2377 2.51389 40.1721 -7.12285 -8.41588 24.6249 -4447 4 19.7963 2.31331 41.0421 14.3479 1.04867 -24.2175 -4448 4 20.7189 1.71371 39.9103 -4.456 1.41042 1.49289 -4449 6 15.0332 14.4679 0.20602 13.2809 -6.14192 -34.7112 -4450 4 15.5535 13.6508 41.8516 -13.9549 30.8146 5.37449 -4451 4 15.3124 15.2392 41.5458 -1.11857 -25.4589 11.3055 -4452 6 24.8198 37.3334 18.5262 -9.71694 12.1129 21.4379 -4453 4 24.5044 38.0178 17.9266 6.55828 0.975012 -4.85481 -4454 4 24.4839 37.6255 19.4009 7.37292 -12.3795 -13.3571 -4455 6 3.16023 27.7824 5.25746 -7.59771 -9.49442 8.09122 -4456 4 2.57386 27.9573 6.05068 26.7372 -11.3185 -11.6141 -4457 4 4.04718 27.3724 5.4685 -26.4098 5.90831 3.92345 -4458 6 37.1274 39.059 36.0582 -20.0626 39.3499 3.12364 -4459 4 37.4397 39.697 36.7497 0.155645 -22.9334 -11.3782 -4460 4 37.5741 38.2261 36.1006 18.9616 -13.4483 8.05827 -4461 6 41.3496 16.372 3.85306 -8.55617 -26.9153 -3.74777 -4462 4 41.2863 17.3336 3.84263 10.0449 1.9656 13.5452 -4463 4 42.0245 15.9886 4.46176 -7.16622 24.1057 -6.4954 -4464 6 15.5715 3.1806 35.3543 4.49903 -8.79025 -44.1337 -4465 4 15.0747 3.51322 34.5661 7.45265 -4.29831 20.3405 -4466 4 15.2394 3.62675 36.1076 -11.9729 17.6287 21.2524 -4467 6 33.1697 24.252 7.98021 17.4163 -35.2043 24.5175 -4468 4 33.373 24.4892 7.07941 -5.88693 14.0606 -13.9779 -4469 4 32.5854 24.8767 8.38373 -10.6809 23.5743 -3.02942 -4470 6 35.8792 29.7453 15.5891 -14.351 2.75051 -7.10357 -4471 4 36.7674 29.6271 15.8378 44.9858 5.9786 2.16229 -4472 4 35.4705 29.0828 16.1298 -19.5083 -3.35284 8.18061 -4473 6 17.5951 36.8258 41.8642 -13.8657 0.640745 -39.4401 -4474 4 18.0986 36.7885 0.752491 19.5286 0.61142 14.8967 -4475 4 18.204 36.9888 41.0995 -4.16013 -2.78766 23.3657 -4476 6 26.5622 4.14757 31.1303 -11.2209 -47.8968 -15.8259 -4477 4 27.2883 4.63526 31.456 28.856 27.2634 11.544 -4478 4 26.9475 3.23966 30.9928 -12.9924 23.1667 5.46977 -4479 6 31.9456 1.33308 34.4467 -12.9904 6.64728 -11.4505 -4480 4 32.8071 1.19449 34.8725 -11.0783 -3.65615 8.33208 -4481 4 31.1956 1.0725 35.0172 18.2758 0.413953 2.527 -4482 6 24.503 14.7492 2.38048 9.24208 -0.0712211 -0.802907 -4483 4 24.1928 14.0003 2.93847 14.4388 11.7071 -7.35684 -4484 4 25.4689 14.9243 2.53228 -19.8697 -9.93034 3.69906 -4485 6 25.7634 20.9148 27.525 0.946636 -0.977661 -1.30084 -4486 4 25.4997 20.5428 28.395 3.38508 9.32598 -11.7317 -4487 4 25.6529 21.8806 27.5755 0.284497 -3.23384 4.14496 -4488 6 18.1477 40.1511 30.6505 2.638 -12.7558 5.82509 -4489 4 18.5379 39.2542 30.773 0.361891 20.0487 -3.45439 -4490 4 18.8736 40.7943 30.5754 -0.793328 -5.73314 0.616918 -4491 6 46.8137 23.9108 24.5765 -6.45001 25.2139 -38.2053 -4492 4 46.156 24.4917 24.0674 25.2521 -23.4518 17.6745 -4493 4 47.3533 23.4819 23.8873 -7.92808 3.44465 4.72259 -4494 6 45.5993 22.6806 26.5072 -4.87261 3.12825 -8.14378 -4495 4 46.0946 22.9584 25.7273 -3.42504 -3.72677 5.16847 -4496 4 46.0209 23.1613 27.2227 -5.79148 -3.32105 5.25932 -4497 6 20.0977 4.47574 26.7104 -1.85738 36.2438 14.3308 -4498 4 20.3766 5.37803 26.4593 -10.8474 -9.08605 12.6513 -4499 4 20.6066 3.98633 26.1049 14.7704 -34.5311 -24.6657 -4500 6 35.268 26.6035 12.5547 25.3434 4.5593 25.1203 -4501 4 35.7054 25.7374 12.5354 -13.4481 2.49909 -6.64065 -4502 4 35.8431 27.0669 13.1929 -15.092 1.56141 -12.9558 -4503 6 3.25549 33.9664 12.2985 -21.2488 -6.99508 3.93395 -4504 4 2.30606 33.7392 12.3085 7.5225 -4.25393 -1.25154 -4505 4 3.25844 34.917 12.332 8.53638 16.5693 1.24934 -4506 6 36.6808 1.27299 25.5856 -28.051 -2.86161 17.5249 -4507 4 37.6164 1.46673 25.6835 8.21338 5.71919 3.59986 -4508 4 36.1703 1.6124 26.3685 15.6278 -2.9361 -18.4357 -4509 6 16.8737 4.664 24.0353 -31.9925 -2.01789 -27.2632 -4510 4 15.8786 4.73848 23.8401 40.5517 -2.65221 8.73903 -4511 4 17.2589 4.19458 23.2519 -3.48506 7.68373 17.7614 -4512 6 39.6701 15.0742 7.83356 -1.71206 -7.05123 2.14494 -4513 4 39.2725 14.2274 8.02711 2.44544 -9.24519 17.4119 -4514 4 39.3892 15.1326 6.9218 7.69265 14.011 -7.76766 -4515 6 9.96731 20.1909 2.92864 -13.1382 1.0323 -16.144 -4516 4 9.71565 20.5309 2.05786 3.65664 7.03968 6.64426 -4517 4 9.8995 19.2377 2.78093 4.24026 5.10291 12.3576 -4518 6 23.4077 4.6159 15.27 -3.48308 -16.1533 -1.5067 -4519 4 23.619 4.71624 14.3536 6.29203 -7.01184 -22.1313 -4520 4 23.1672 5.50294 15.4683 -4.33935 19.8524 20.6561 -4521 6 23.5267 41.6518 17.9122 -9.44104 0.807914 21.3506 -4522 4 23.7067 41.2659 18.7956 7.59245 -0.294373 -11.029 -4523 4 22.6339 0.0834245 18.0732 1.82991 3.48892 -13.1537 -4524 6 30.9316 4.82324 1.33107 45.9774 51.3713 7.99935 -4525 4 30.5768 4.02682 1.05687 -28.0042 -54.4029 -17.3695 -4526 4 31.8094 4.8761 0.879215 -15.6392 -0.833181 8.5221 -4527 6 29.2201 33.7587 18.5991 58.073 2.92721 -1.85527 -4528 4 30.1837 34.1183 18.6008 -42.2538 -17.2347 0.0641557 -4529 4 28.6837 34.5413 18.5643 -15.6262 17.5996 3.33909 -4530 6 23.1221 16.7099 3.68521 11.8431 -16.3115 0.0733348 -4531 4 23.6562 16.338 2.95547 -9.45134 2.67217 9.8165 -4532 4 23.048 17.6538 3.54099 -2.31098 6.59774 -1.54538 -4533 6 34.8961 26.7639 31.7325 -1.99602 4.46994 3.67284 -4534 4 35.0929 27.7139 31.562 -2.18198 -17.8875 -5.58085 -4535 4 35.0252 26.2302 30.9312 2.47742 18.1005 -1.54363 -4536 6 7.11189 40.7663 20.959 14.901 4.90705 15.7674 -4537 4 6.49418 40.4573 20.3006 -5.17655 -2.88906 -15.6427 -4538 4 7.9749 40.9101 20.5297 -6.61986 -3.78335 -7.15935 -4539 6 52.4451 9.69387 11.9379 -8.46192 -13.0679 -16.1645 -4540 4 52.1167 8.90553 11.4509 5.46474 18.3719 13.4625 -4541 4 53.1134 10.0871 11.3593 -6.16158 -0.354597 4.80602 -4542 6 12.0344 32.7576 27.7445 1.28323 7.36678 12.5499 -4543 4 11.2848 32.2741 27.3627 7.37999 2.33687 -5.47139 -4544 4 12.7987 32.654 27.1746 -1.40521 -5.62475 -4.84597 -4545 6 15.7821 18.5441 0.84801 8.76354 -4.35468 -11.8188 -4546 4 16.4439 18.9467 1.42581 -3.0166 1.81121 1.10538 -4547 4 14.9492 18.5892 1.29924 -12.8156 0.756803 9.02992 -4548 6 30.9925 13.9418 7.42386 -4.40747 -9.92517 -19.1249 -4549 4 31.0137 13.4754 6.53341 6.38174 17.9129 28.0089 -4550 4 31.6996 14.6103 7.52177 -5.32565 -11.3142 -7.68087 -4551 6 23.9405 39.5605 3.5435 10.8606 -6.43074 -8.73391 -4552 4 24.3095 38.7805 4.04208 -2.00396 18.4511 -18.0645 -4553 4 24.6123 39.8651 2.88148 -9.69774 -9.50421 15.8523 -4554 6 53.2462 13.9551 2.00337 -15.5118 -12.0942 -3.71099 -4555 4 54.104 14.269 2.28215 12.5804 5.35006 1.30654 -4556 4 53.0522 14.3304 1.13281 7.32968 -0.777694 2.32044 -4557 6 29.4483 26.4268 7.81741 -0.171572 11.4439 -18.4732 -4558 4 29.8672 26.7876 7.00927 -3.33338 -4.99995 18.6366 -4559 4 28.5088 26.3872 7.58736 -4.03891 -2.78124 5.15679 -4560 6 24.6251 23.6043 31.0935 -26.8137 17.7603 -44.4691 -4561 4 23.7139 23.2229 30.9355 29.773 11.0738 8.78977 -4562 4 24.7983 24.2076 30.2965 -2.98074 -30.8217 36.523 -4563 6 33.658 19.3188 40.511 -4.29932 4.0975 7.85681 -4564 4 33.8365 18.6271 41.1728 0.0947513 0.993086 -5.72158 -4565 4 34.3002 19.2334 39.7953 0.390848 -1.03282 -3.03706 -4566 6 0.558986 35.9852 14.2205 11.1667 11.0015 21.0521 -4567 4 1.21386 36.1432 14.9149 3.92292 -5.96876 -2.97707 -4568 4 0.043734 36.7876 14.3014 -15.3768 6.08493 -10.5247 -4569 6 7.05222 12.7587 15.7802 -26.1824 -15.4106 14.8382 -4570 4 6.35773 12.5373 16.4499 19.2033 7.53925 -13.5919 -4571 4 6.88557 12.0803 15.1093 4.12905 5.75416 0.888 -4572 6 7.8802 3.87979 22.4264 4.564 -30.6165 13.1651 -4573 4 7.61737 4.55637 21.8154 -5.12813 13.4305 -13.5146 -4574 4 7.59435 3.01808 22.0419 3.92228 16.9329 8.71162 -4575 6 50.747 32.0919 16.246 0.584829 29.9532 -6.88448 -4576 4 49.8575 31.8158 16.477 -3.66132 0.0213613 -0.234359 -4577 4 50.6533 33.048 15.9617 2.92819 -31.696 10.1835 -4578 6 15.3083 18.2099 30.0577 17.4273 -12.3999 25.5818 -4579 4 14.8795 18.523 29.2753 -13.2188 2.60124 -19.4058 -4580 4 14.9888 17.3027 30.2404 2.47215 8.3937 -6.40515 -4581 6 36.7253 25.4508 33.3862 -30.1432 30.6395 -17.6873 -4582 4 35.9871 25.9696 32.8546 42.334 -36.2451 27.5582 -4583 4 36.7428 24.5171 33.143 -7.68133 1.91065 -3.3758 -4584 6 16.5208 21.8449 20.262 -11.2097 8.64672 -3.63533 -4585 4 16.6085 20.9267 19.9682 1.68058 -0.497742 -2.90804 -4586 4 16.3112 22.3946 19.4823 4.36577 -8.59001 6.07269 -4587 6 44.2833 3.11948 30.0766 -7.99673 -6.73576 30.9987 -4588 4 44.2005 2.2232 29.7402 -0.794022 -7.70278 -4.62871 -4589 4 44.5183 3.67066 29.3503 7.77568 15.2131 -24.9404 -4590 6 51.0808 14.1269 27.7758 -27.047 -14.2895 -4.28411 -4591 4 51.175 15.071 27.7901 8.66575 19.7266 0.878182 -4592 4 50.1173 14.0309 27.5969 15.0189 -4.76366 3.10402 -4593 6 54.1497 15.8755 27.1203 10.9044 -5.07506 15.753 -4594 4 54.6247 15.0341 27.411 -19.35 18.5916 -21.6107 -4595 4 53.6213 15.8397 26.2863 11.6919 -13.2292 13.7718 -4596 6 26.7269 15.1716 34.5247 3.07047 6.28357 -2.56105 -4597 4 26.6547 16.15 34.5201 9.87746 -16.6036 -4.19036 -4598 4 27.4477 14.9176 33.917 -5.54963 13.4877 1.89491 -4599 6 34.6713 2.21044 27.481 35.3652 -9.42756 14.1603 -4600 4 34.3712 2.0217 28.3795 -9.10436 3.38048 -0.887416 -4601 4 33.9282 2.37922 26.9258 -24.4077 6.67858 -6.22498 -4602 6 36.3012 17.6491 40.388 5.86113 23.4658 6.44349 -4603 4 35.7206 17.1804 39.7974 -3.43874 -12.7236 -2.47465 -4604 4 36.6864 17.0408 41.0377 -6.22241 -0.114851 -7.42509 -4605 6 26.2819 0.194243 33.0916 -21.1162 -1.74839 5.89968 -4606 4 26.0541 0.792538 33.818 7.17118 8.51167 2.05738 -4607 4 25.4361 41.6393 33.0097 0.772233 -7.73624 -3.23605 -4608 6 5.19547 35.5715 31.6247 14.6733 -21.492 26.4929 -4609 4 6.10271 35.831 31.8735 -9.75028 2.17691 -1.53344 -4610 4 4.97694 36.0548 30.8519 -3.41417 18.4244 -29.6169 -4611 6 20.2195 22.0294 35.119 8.25657 -3.203 11.321 -4612 4 19.9286 21.1888 34.7559 -2.68712 -4.78598 1.15285 -4613 4 20.5567 21.7901 36.0152 -5.29706 4.10974 -20.8318 -4614 6 15.9087 36.5843 36.9399 0.69981 -30.9087 31.3945 -4615 4 16.5764 37.2836 37.0377 -3.33596 -3.14632 -1.27145 -4616 4 16.032 35.9777 37.754 -5.87689 21.7482 -34.0408 -4617 6 30.95 22.3912 3.57027 12.227 -51.3484 -20.5494 -4618 4 31.0645 22.6091 4.4902 1.82476 2.59415 19.1922 -4619 4 31.2691 21.4218 3.50648 -13.7255 40.3499 2.75328 -4620 6 47.0405 8.41049 14.2025 -7.26712 -13.7585 -23.7685 -4621 4 46.2225 8.31623 13.6472 18.9804 2.55096 13.7682 -4622 4 47.7321 7.85584 13.7597 -18.0416 11.4216 8.02226 -4623 6 34.1106 18.627 3.15563 -0.4946 23.1394 22.2065 -4624 4 34.672 18.2914 3.86301 0.996255 -3.71784 -4.49801 -4625 4 34.2399 18.1173 2.36738 0.542984 -13.2578 -17.3669 -4626 6 26.7976 25.3916 12.343 -23.6037 -44.5624 17.4882 -4627 4 27.2059 26.2338 12.4335 13.1462 29.8808 4.32264 -4628 4 26.6887 24.995 13.243 7.37483 11.5945 -21.6739 -4629 6 22.6215 25.7777 30.8835 17.9212 -8.3502 11.6983 -4630 4 23.3826 25.7056 31.4928 -6.70991 6.16838 -4.71983 -4631 4 22.2455 24.8881 30.8847 -4.10822 -0.13742 -3.2228 -4632 6 23.6315 9.78689 35.7599 5.48292 -2.30097 -0.625566 -4633 4 22.8113 10.2893 35.7248 -4.77612 1.7474 -0.383276 -4634 4 23.3643 8.87406 35.5171 2.31753 16.9109 3.97959 -4635 6 10.4044 36.7742 9.63922 -25.0741 -4.1625 3.51028 -4636 4 9.48479 36.4361 9.55892 17.1497 7.1291 1.06445 -4637 4 10.7029 36.9295 8.73946 3.49181 4.27039 -8.54773 -4638 6 4.00239 32.4234 25.8687 17.3833 10.7639 11.9139 -4639 4 4.35688 32.9952 25.1699 -1.7627 -0.965582 -1.95819 -4640 4 3.3252 31.8731 25.4905 -12.2764 -14.2405 -10.2138 -4641 6 29.0717 26.0252 18.6551 27.2015 -27.7815 2.54409 -4642 4 28.1485 25.9947 18.9226 -9.28828 -8.18845 2.68073 -4643 4 29.5616 25.1801 18.9271 -24.0321 31.3207 -7.4501 -4644 6 15.3034 1.33037 27.9713 -8.15532 13.2931 -1.88459 -4645 4 14.9824 0.900448 27.1643 -4.10476 8.37726 9.18093 -4646 4 14.8435 2.19317 28.1161 8.64797 -17.4448 -9.70896 -4647 6 48.6122 2.88813 22.9601 -14.0575 20.6462 10.9468 -4648 4 48.3097 2.01316 22.7294 4.97712 -8.72373 -1.92059 -4649 4 49.4728 3.0448 22.5739 5.56154 -9.57595 -10.4155 -4650 6 53.0134 0.348391 19.7218 2.72624 -2.60203 -3.14968 -4651 4 52.5877 42.0257 20.5538 -0.625041 0.289898 3.74318 -4652 4 52.305 0.305612 19.0628 -0.905041 -0.864478 -1.55308 -4653 6 1.39118 17.4858 17.9447 -8.50794 14.6458 12.7327 -4654 4 1.24353 17.4779 16.9894 -1.31782 -10.0732 -1.96873 -4655 4 1.47925 16.6123 18.3551 -1.8326 -9.29856 -10.4725 -4656 6 37.8975 19.0277 37.6053 -28.6618 15.029 -11.7184 -4657 4 36.9647 18.7897 37.7838 11.6122 1.96204 1.16191 -4658 4 38.4406 18.4447 38.1174 10.3965 -16.3488 12.6679 -4659 6 26.9855 30.3558 38.071 9.50079 1.40194 -4.36533 -4660 4 26.0886 30.216 37.7369 5.39533 7.19535 -1.12484 -4661 4 27.2954 31.2276 37.7499 -13.0308 -11.5285 -0.168161 -4662 6 20.0885 18.5747 3.04679 -6.02291 21.5949 -15.2672 -4663 4 19.9787 17.7407 3.50085 7.53739 -11.7285 12.3408 -4664 4 20.8981 19.0299 3.33477 -4.38138 -14.9723 0.744253 -4665 6 35.0861 6.94018 4.08702 3.04221 -3.62035 -0.583554 -4666 4 35.6351 7.18342 3.33325 6.4301 -2.1748 -2.62446 -4667 4 34.2564 7.39563 3.93984 -10.6534 0.652929 2.2495 -4668 6 22.2213 37.08 31.2556 -28.1532 13.1327 42.6182 -4669 4 22.1563 36.8958 30.3458 -2.68084 -5.78815 -35.014 -4670 4 21.2899 37.3194 31.5407 35.2494 -6.03647 -12.8067 -4671 6 12.3954 22.364 41.8234 21.4337 26.9075 -8.21443 -4672 4 12.9612 23.1595 41.5956 -22.2624 -27.6618 12.5485 -4673 4 11.7092 22.295 41.1522 0.74395 2.83494 0.343647 -4674 6 43.2331 30.3213 23.157 26.8689 32.5799 1.85734 -4675 4 44.1495 30.0558 22.8796 -21.7207 5.89602 6.32158 -4676 4 43.3514 31.2801 23.4416 -6.45211 -30.9956 -6.78246 -4677 6 16.5257 8.07813 16.6617 -19.4309 -12.5216 11.6481 -4678 4 16.3886 8.34983 15.7476 7.00958 2.01583 -5.14722 -4679 4 17.4107 8.32004 16.9428 8.9294 8.4681 -2.86418 -4680 6 10.0506 8.65043 31.7756 -2.39508 10.2278 -10.4865 -4681 4 10.14 7.97578 32.4103 1.95442 -36.8206 12.1998 -4682 4 10.116 9.39125 32.3649 -0.107045 27.388 0.472024 -4683 6 10.1509 6.49695 25.6483 14.6726 -6.33183 2.00995 -4684 4 9.37694 6.15153 26.0805 -12.3653 -8.75157 5.1154 -4685 4 9.82248 7.1865 25.0601 3.70088 -0.958502 2.30736 -4686 6 49.8668 7.2369 25.5225 -24.0329 9.97804 -6.35029 -4687 4 50.053 6.31696 25.3599 8.14544 -13.6468 -2.92498 -4688 4 50.6696 7.6642 25.7982 18.0374 4.82749 5.17198 -4689 6 18.4641 37.5693 33.932 -1.74635 9.46172 -1.89257 -4690 4 17.7617 38.2474 34.0853 10.1616 -18.2299 -3.47398 -4691 4 18.0542 36.6946 34.0238 -8.30855 4.53024 1.19921 -4692 6 32.1897 34.7964 39.2558 32.2313 -17.5381 13.0656 -4693 4 32.48 34.3381 40.0896 -7.23509 10.7133 -18.5379 -4694 4 31.2879 35.0284 39.3813 -31.6037 5.0658 8.82 -4695 6 49.5304 23.9104 4.45569 25.8701 3.67026 -38.321 -4696 4 49.7808 23.1947 5.01942 4.2809 -18.8946 17.0996 -4697 4 48.8132 24.3493 4.85794 -31.8244 16.1567 21.064 -4698 6 6.0606 24.4992 33.9345 -0.638471 -2.64646 7.7036 -4699 4 6.7001 23.7849 33.7997 2.17947 5.97399 -8.00372 -4700 4 5.47521 24.1274 34.6146 -0.567039 8.82042 -5.77933 -4701 6 1.71497 22.9937 24.1827 2.23241 21.1509 -1.27791 -4702 4 1.62302 23.9425 23.95 -0.486435 -10.8617 3.92094 -4703 4 0.825214 22.7289 24.4403 -5.44701 -4.12175 2.39318 -4704 6 12.4657 16.5565 32.3481 -44.3953 42.3465 -23.9812 -4705 4 13.2256 16.0186 32.4214 25.6927 -27.9273 24.4997 -4706 4 11.8347 16.6394 33.1026 23.5286 -12.3088 -0.369419 -4707 6 21.3722 37.3857 27.9432 8.33623 1.67622 30.3175 -4708 4 21.2745 37.3852 27.0022 -8.47587 6.30229 -26.1478 -4709 4 20.7646 38.0573 28.2974 0.343549 -1.37388 -6.67046 -4710 6 27.2371 40.835 28.8059 -14.5618 2.70883 26.0148 -4711 4 26.5104 41.4636 28.9519 7.17104 -1.72995 -14.6333 -4712 4 27.2442 40.3637 29.6524 5.83721 -3.62297 -8.28664 -4713 6 0.999535 21.7321 13.5318 -29.3194 4.17708 -0.571391 -4714 4 1.85706 21.6318 13.8745 50.1621 -4.04822 5.83187 -4715 4 0.493313 21.4968 14.3164 -12.4374 2.61082 -2.41507 -4716 6 22.3196 2.57547 8.74609 19.5097 -5.43411 17.7027 -4717 4 22.9517 3.10624 8.26305 13.4452 6.72454 -0.92593 -4718 4 21.5477 2.63817 8.2102 -22.9662 -0.14239 -10.9727 -4719 6 29.9886 17.8486 8.24374 -1.93571 4.49032 -2.67939 -4720 4 29.0601 17.6146 8.32603 -5.42798 -1.41354 1.1127 -4721 4 30.4131 17.4547 9.01282 4.29332 -3.23535 5.29369 -4722 6 3.62824 37.7086 25.7053 -21.3362 8.32154 -6.60892 -4723 4 4.42904 37.184 25.8405 -4.94962 -9.47676 -0.42012 -4724 4 2.83762 37.1591 25.4673 21.6133 3.65171 5.88982 -4725 6 26.7972 27.6476 36.3581 -47.4115 -5.5291 12.7506 -4726 4 26.8465 28.2624 35.6306 8.29087 8.74477 -10.4705 -4727 4 25.8218 27.6191 36.6005 30.1762 -0.597939 -6.56813 -4728 6 13.3509 25.3111 38.1214 6.90903 -15.9492 13.2692 -4729 4 13.3459 24.3911 38.4732 0.919555 17.3618 -5.73458 -4730 4 14.144 25.7168 38.5298 -8.43807 -1.25323 -5.48633 -4731 6 49.7161 27.2636 6.73274 -18.8339 5.2299 -32.7408 -4732 4 49.5935 26.3653 6.40806 5.58405 -0.645115 8.82912 -4733 4 49.2001 27.7791 6.04852 15.3529 -4.94049 26.886 -4734 6 39.7451 11.5811 10.2076 8.75523 -9.51322 -11.6408 -4735 4 40.371 10.9447 9.80262 -5.32314 14.1891 9.76509 -4736 4 39.1233 11.799 9.49079 2.50191 2.43793 7.76023 -4737 6 17.4883 24.9894 35.5591 -19.4762 1.01983 7.35275 -4738 4 17.0975 24.7887 34.694 2.72786 0.423626 1.28381 -4739 4 18.4353 24.8575 35.5073 10.004 -2.92602 -7.93295 -4740 6 45.0832 34.9807 31.8277 24.5651 -3.79623 6.38158 -4741 4 44.3095 35.5111 32.0501 -8.6141 -4.27399 -12.5931 -4742 4 44.9123 34.3632 31.1055 -12.5508 0.508806 -0.453023 -4743 6 30.2187 9.89463 31.3271 7.05348 4.55507 6.68413 -4744 4 30.4541 10.7656 30.9635 -3.12777 -8.04008 8.45875 -4745 4 30.1355 10.0083 32.293 1.90576 1.32601 -8.54322 -4746 6 32.3712 9.2149 6.61373 28.8381 -35.7198 -39.9492 -4747 4 32.1726 8.66567 5.78496 5.01502 20.0116 29.9298 -4748 4 31.5547 9.49954 6.96481 -36.3246 12.521 14.22 -4749 6 9.26959 24.9556 35.9161 1.96832 15.842 -17.2096 -4750 4 8.91298 25.4858 35.1726 -0.127744 -15.1166 11.0351 -4751 4 9.85583 25.5957 36.3463 -2.24606 -10.0757 2.02076 -4752 6 40.3298 1.49261 18.8755 10.6299 1.30292 -21.7 -4753 4 39.6194 1.80532 19.3944 -35.8146 17.5344 12.5449 -4754 4 40.7796 0.936194 19.4956 21.1502 -18.4862 6.40423 -4755 6 5.26901 10.6323 30.4328 -1.07618 -0.575959 25.8078 -4756 4 5.0059 11.4532 29.9824 1.00544 3.53991 6.4134 -4757 4 5.36238 10.8297 31.4225 -4.75078 2.46468 -31.0333 -4758 6 25.6472 11.7043 25.6564 -2.85241 -30.912 5.54365 -4759 4 25.9319 12.4737 26.1319 5.23872 14.1859 6.15637 -4760 4 25.9893 10.9537 26.204 -5.41829 19.961 -14.7301 -4761 6 21.91 20.0664 29.7913 -6.2328 1.4725 0.460556 -4762 4 22.5319 20.0532 30.5545 -13.0709 -9.05965 -9.53591 -4763 4 21.5487 19.1817 29.5606 11.8355 8.09924 7.60661 -4764 6 10.008 19.9919 34.5046 11.2891 -12.0839 -11.2138 -4765 4 9.40296 20.4589 35.0806 -5.60052 -0.834193 8.04722 -4766 4 10.0208 19.0442 34.745 -1.06298 11.667 -2.12072 -4767 6 24.6334 10.3662 12.209 5.25257 18.8662 20.0118 -4768 4 24.6941 9.47775 12.5956 1.57271 8.96717 -2.9517 -4769 4 24.9719 11.0034 12.9045 -11.2568 -27.0384 -15.8586 -4770 6 50.4496 28.283 11.5446 48.5969 7.21476 -25.6728 -4771 4 51.3012 28.7385 11.2434 -32.0883 -19.6524 11.3949 -4772 4 50.1145 28.8771 12.2081 -10.2548 6.02908 11.3498 -4773 6 13.9159 27.6234 25.0588 -25.6331 11.4059 -15.4978 -4774 4 13.5005 28.0493 25.83 5.93925 -3.01588 -8.8098 -4775 4 13.4276 28.0022 24.2718 14.6036 -12.4854 23.8457 -4776 6 46.1589 18.6653 40.4078 -23.2184 -0.389309 -10.7846 -4777 4 45.2349 18.5626 40.0761 15.1795 0.391647 5.46432 -4778 4 46.2048 19.5984 40.6658 -0.558864 -5.77386 -4.91212 -4779 6 32.4746 14.176 27.1227 -16.003 2.1806 5.505 -4780 4 31.9042 13.6172 27.6867 7.52463 5.83279 -7.70325 -4781 4 32.1655 15.0897 27.2802 4.78128 -6.53963 -2.41902 -4782 6 14.0556 36.3553 13.3828 19.8073 6.5728 22.6139 -4783 4 14.1017 37.3298 13.5875 -14.1879 -23.5484 -13.1576 -4784 4 13.3212 36.1206 12.8052 -8.41953 14.8686 -5.40295 -4785 6 1.88392 36.5802 21.9963 -4.52806 -9.18778 1.34501 -4786 4 1.78058 36.5165 22.9531 -3.13652 -1.22736 7.08711 -4787 4 2.81062 36.8013 21.8509 3.08344 1.49572 -0.20158 -4788 6 25.283 31.8665 39.7486 -0.0346121 -4.3463 21.3102 -4789 4 24.9491 32.7147 39.4474 -1.97702 6.83441 1.95234 -4790 4 25.5262 31.9404 40.7015 -5.12155 2.92558 -20.0537 -4791 6 6.47988 22.0137 1.28428 -12.6715 -7.61279 -4.66874 -4792 4 5.53909 21.8738 1.48571 10.6555 3.73696 2.93659 -4793 4 6.5727 22.8978 0.916948 1.0061 5.37498 -0.183021 -4794 6 27.6236 25.0404 4.70626 6.00578 18.2896 15.2827 -4795 4 28.5331 25.4118 4.61276 -17.9968 -6.47987 4.19831 -4796 4 27.2352 25.3966 5.54825 13.7859 -6.49357 -18.8943 -4797 6 21.6401 30.9371 41.2305 6.69834 21.9548 -27.1087 -4798 4 21.276 30.3289 41.855 -17.7491 -18.0709 13.8774 -4799 4 21.0024 31.0127 40.4783 8.64888 -5.56942 17.5854 -4800 6 32.355 18.8729 12.7674 13.4209 4.31066 2.75957 -4801 4 31.3956 18.9706 12.835 4.55688 -5.10905 -10.5867 -4802 4 32.607 18.5493 11.8826 -7.53687 3.28724 6.30822 -4803 6 35.6452 19.4617 21.1556 -9.82604 19.2175 8.60555 -4804 4 35.3405 18.5718 21.3708 -2.26659 -3.59924 -3.4629 -4805 4 34.936 20.0876 21.4701 16.8427 -19.1907 -7.36791 -4806 6 27.6904 17.9595 34.0135 2.51947 12.848 9.8691 -4807 4 28.1207 18.371 33.2456 -3.55582 0.0466306 5.59907 -4808 4 28.0719 18.4525 34.7708 -4.77519 -7.99763 -12.3529 -4809 6 34.1913 39.0308 14.8198 -32.2909 7.81486 42.3772 -4810 4 33.7378 38.3849 14.2709 2.40292 -0.641653 -5.60016 -4811 4 33.4938 39.1934 15.5434 31.6198 -1.67931 -26.5413 -4812 6 28.5078 3.47132 33.888 -4.80695 9.04662 2.15546 -4813 4 27.9441 4.2497 33.8725 -11.1427 -2.20885 -1.07295 -4814 4 29.3801 3.85895 33.8332 18.6007 -6.2612 -1.20104 -4815 6 34.9259 32.1312 6.54177 -41.0464 -12.9808 21.9467 -4816 4 34.0171 32.0297 6.98271 38.7419 4.2921 -24.6555 -4817 4 35.5211 32.1736 7.29951 5.76537 -1.35874 -3.25655 -4818 6 31.8896 6.8799 23.5232 0.89208 3.44668 5.58958 -4819 4 32.4231 6.58347 22.7679 -0.16899 1.4285 3.8543 -4820 4 32.2407 7.75715 23.7826 1.29066 -6.24882 -6.25814 -4821 6 18.8559 1.76458 0.828337 -20.5472 23.3683 -17.7838 -4822 4 18.0266 2.11952 0.42761 13.2396 -12.575 3.84382 -4823 4 19.0445 2.38904 1.53279 3.18086 -1.81057 9.578 -4824 6 26.9929 18.9294 11.856 68.8676 -4.65359 -28.5611 -4825 4 27.3133 19.7685 11.4551 -15.5879 -7.28987 7.59546 -4826 4 26.1136 18.988 12.1267 -55.7646 13.8464 15.3945 -4827 6 43.8351 11.1458 18.4443 23.0031 -19.5153 4.50837 -4828 4 43.638 10.8812 17.5537 -13.1544 4.18059 -17.1583 -4829 4 44.5589 10.5175 18.6246 -1.75483 13.9327 9.72942 -4830 6 33.4946 40.5615 37.6755 15.4013 8.76106 -9.33396 -4831 4 34.0096 40.2689 38.4502 -12.4229 -1.46966 -1.83753 -4832 4 32.5786 40.2698 37.7667 -1.95229 -4.85928 9.55413 -4833 6 15.6186 26.7023 39.419 -29.2453 -49.1617 7.39509 -4834 4 15.4971 26.9949 40.3155 1.17426 12.5786 14.7177 -4835 4 16.1446 27.3092 38.9602 29.5915 33.502 -22.8309 -4836 6 4.38071 13.8775 40.883 9.27553 -14.126 -4.37485 -4837 4 5.31782 13.6454 41.0342 -11.8393 4.50398 0.960258 -4838 4 4.04834 13.2497 40.2173 2.13772 10.7877 7.68198 -4839 6 20.1656 10.4005 38.218 10.8779 4.82467 -13.4554 -4840 4 20.4848 10.7245 37.3555 -10.2589 -5.36296 0.708096 -4841 4 20.9923 10.2607 38.6798 -1.28838 -2.71386 11.844 -4842 6 15.1666 19.24 23.8849 4.49083 -8.21488 3.46045 -4843 4 15.3253 20.1347 24.2296 -1.0797 -1.90309 -4.08137 -4844 4 15.0239 19.3391 22.9299 0.969961 5.53483 11.956 -4845 6 47.8934 28.614 15.7995 12.3109 16.1315 8.54118 -4846 4 47.9523 27.7003 15.5425 0.10403 -15.196 -3.00888 -4847 4 48.6265 28.752 16.4246 -6.57835 -5.21115 -6.70139 -4848 6 29.9259 30.9075 18.965 7.62461 4.23841 -1.37457 -4849 4 29.1117 30.4308 18.7732 -7.06282 -5.88302 -2.4339 -4850 4 29.7134 31.8391 18.8515 -2.57834 1.4724 1.74445 -4851 6 11.9338 35.8178 28.497 -7.27451 6.14295 -10.3733 -4852 4 12.5041 35.9802 29.2427 6.70347 11.4983 16.16 -4853 4 12.1847 34.9375 28.2428 -3.53576 -18.0038 -9.26428 -4854 6 29.972 37.8772 25.486 -12.1052 4.73031 -22.3992 -4855 4 30.2553 36.9663 25.6711 3.40868 8.54106 4.83275 -4856 4 30.3747 38.5051 26.0898 8.03536 -1.45294 10.6494 -4857 6 52.6584 28.1048 32.275 31.4311 4.91254 4.04956 -4858 4 52.2473 28.8547 31.8392 -9.38068 2.35947 -3.12986 -4859 4 53.5924 28.4001 32.3224 -6.05351 -9.99886 1.81474 -4860 6 37.0156 40.0823 11.982 15.2095 -8.99172 -8.52195 -4861 4 36.22 40.5624 12.1833 -15.2617 4.79593 6.40041 -4862 4 37.4101 39.8767 12.8402 0.665617 -0.484924 4.09883 -4863 6 16.6662 16.7824 36.4899 -23.6543 20.4081 -13.3107 -4864 4 16.0299 17.4889 36.7962 20.061 -22.8424 -10.9222 -4865 4 16.728 16.9177 35.5139 -3.3638 -0.555369 18.7216 -4866 6 27.9984 4.17668 38.8431 -6.8633 -1.77316 4.22536 -4867 4 28.9161 4.3061 39.1095 4.06977 1.67187 2.70396 -4868 4 28.0368 3.69267 38.0106 -3.95018 -5.40445 -5.6405 -4869 6 28.9057 0.266004 17.7212 -6.10073 29.2375 -5.44551 -4870 4 28.1786 0.88303 17.5246 8.92385 1.95552 -1.67076 -4871 4 28.4447 41.3635 17.8399 -11.0591 -30.1495 5.35559 -4872 6 22.9291 20.1009 26.2737 12.905 2.01461 18.3128 -4873 4 23.6265 20.0378 26.9508 -1.05622 -6.52034 -10.1156 -4874 4 22.4706 20.8929 26.5742 -3.00423 3.39878 -4.61403 -4875 6 49.3993 29.9017 13.433 -6.38025 27.1117 -0.919919 -4876 4 49.1201 30.8275 13.1802 1.84527 -26.9682 8.98406 -4877 4 48.7504 29.5045 14.041 1.51099 8.43883 -0.914593 -4878 6 2.44855 24.8301 7.30401 -10.5471 2.4163 20.698 -4879 4 2.41495 24.6588 8.2845 -1.1432 9.4633 -23.8545 -4880 4 1.72338 25.455 7.1058 6.30785 -9.44609 7.39061 -4881 6 30.3915 26.4508 14.3344 -6.38639 41.9339 41.7386 -4882 4 31.0669 26.3804 15.0403 -0.162406 -14.5956 -15.076 -4883 4 29.932 27.2875 14.6522 8.5071 -34.3491 -22.1885 -4884 6 27.0361 32.5047 3.13805 -13.013 14.5566 5.91638 -4885 4 26.4776 33.1542 3.63465 13.8957 -14.3888 -12.6314 -4886 4 27.3381 31.8882 3.81715 0.997102 -1.94867 -0.811892 -4887 6 34.2693 14.8073 1.28197 14.9869 -24.9335 -24.2287 -4888 4 35.1732 14.4308 1.1613 -12.3133 12.1546 9.27146 -4889 4 33.7818 14.2606 0.617478 5.51233 18.0169 18.4334 -4890 6 30.0243 8.54272 1.33127 -15.3984 1.11418 15.9731 -4891 4 29.9557 9.47917 1.12547 1.89625 5.05184 -1.94546 -4892 4 29.278 8.4251 1.95594 13.4411 -5.55834 -8.66406 -4893 6 42.5535 11.5155 27.7085 15.437 -3.44919 -13.726 -4894 4 42.3225 12.4337 27.8881 -6.79772 -1.02898 5.45325 -4895 4 41.899 10.9203 28.077 -14.0379 1.06089 7.70623 -4896 6 52.4658 39.5603 17.8381 6.64956 -28.6351 -32.0971 -4897 4 51.7413 39.7621 18.3991 -22.9429 13.2738 25.1291 -4898 4 53.1708 40.1592 17.9962 19.9289 22.995 10.0024 -4899 6 33.211 4.92827 31.629 -12.2211 32.167 9.39859 -4900 4 32.8163 5.83971 31.6275 7.84415 -21.2817 2.59476 -4901 4 32.9135 4.52627 30.8083 -0.68235 -2.18314 -5.10952 -4902 6 6.29493 15.9859 18.7482 13.6791 10.985 9.78561 -4903 4 5.93033 16.6016 19.4273 2.88753 -17.718 -13.1605 -4904 4 5.60754 15.3724 18.4768 -10.6912 0.909102 4.08099 -4905 6 8.51749 14.5386 24.6879 -5.02573 1.07483 -2.93277 -4906 4 9.38168 14.4087 25.0828 4.4136 1.3116 3.34168 -4907 4 8.20169 13.6557 24.4566 1.37146 0.850768 1.15416 -4908 6 22.6856 10.1159 32.1347 3.63858 -5.5341 -7.29103 -4909 4 22.4401 11.0127 32.2731 -27.0162 20.0988 15.0061 -4910 4 23.4682 10.3148 31.6383 25.2173 -15.197 -13.8617 -4911 6 11.2884 2.11431 14.6724 -33.0968 -7.95794 -19.898 -4912 4 10.3134 2.08073 14.4479 21.8664 -1.34414 10.3974 -4913 4 11.7152 2.30811 13.8211 9.70644 2.30495 0.939267 -4914 6 44.9099 15.5878 36.2745 25.7257 2.41581 -13.4012 -4915 4 45.0546 15.5553 35.3019 -10.2235 2.9059 20.3658 -4916 4 43.9848 15.4747 36.4307 -17.7944 -2.84066 -0.111047 -4917 6 9.72168 19.0116 31.2214 10.0341 -21.2505 -12.9994 -4918 4 10.5925 19.389 31.3727 0.996524 0.534629 3.32861 -4919 4 9.08651 19.5363 31.6795 -15.0033 12.5653 12.9482 -4920 6 51.9861 7.59179 16.6767 -2.21949 13.5197 0.492591 -4921 4 52.6037 6.8327 16.6765 -16.3843 6.63384 -16.8766 -4922 4 51.5083 7.75362 15.8118 21.6515 -16.4571 17.7861 -4923 6 31.4364 34.7816 36.4086 3.08769 21.0155 -3.2672 -4924 4 31.7704 34.8477 37.2975 8.82098 -13.2304 13.8104 -4925 4 31.3443 35.7177 36.1951 -3.32863 3.82124 -15.3061 -4926 6 4.22848 15.0876 15.3675 -15.1793 -4.71932 15.5862 -4927 4 4.10446 14.9036 16.3273 5.02277 2.80423 -15.2934 -4928 4 5.16622 15.2495 15.2447 10.6913 1.67801 0.337818 -4929 6 47.7535 20.6847 28.0297 3.73811 3.24498 -1.95167 -4930 4 47.6703 19.7739 27.6852 3.21079 12.9013 3.0329 -4931 4 48.3469 21.1738 27.4217 -9.1514 -8.95746 6.26441 -4932 6 15.7983 1.14885 24.4111 -6.64534 16.957 -16.446 -4933 4 15.3695 0.397874 24.8496 -11.2605 5.13601 -9.62176 -4934 4 15.1572 1.72115 23.8957 14.1067 -25.56 23.4483 -4935 6 34.5718 39.7067 40.0668 -5.06722 14.7699 1.92827 -4936 4 34.1159 40.1215 40.7935 -0.0189783 27.8984 7.01187 -4937 4 34.2456 38.8495 40.221 -5.22714 -44.7262 -10.8544 -4938 6 20.1936 32.176 34.4055 -22.5016 27.7868 41.3602 -4939 4 19.6673 32.7687 35.0502 14.2298 -29.0143 -30.198 -4940 4 21.0584 32.1328 34.8407 -2.28869 -2.39527 -4.5293 -4941 6 19.3074 38.5208 11.8317 17.689 14.4135 -2.63233 -4942 4 19.236 37.5914 12.0232 -0.177798 -10.0936 4.99209 -4943 4 20.0172 38.8749 12.4245 -13.7536 -7.85063 -8.99287 -4944 6 6.52955 13.5023 26.836 -16.6143 37.6784 -17.6139 -4945 4 6.084 14.0762 26.1427 18.8957 -21.2062 24.9102 -4946 4 6.49663 12.6281 26.4634 0.197125 -15.4908 -4.14034 -4947 6 23.5952 31.5638 33.3318 1.16311 -12.5666 -5.83621 -4948 4 23.0836 31.562 34.1475 0.610672 3.97154 0.891929 -4949 4 23.5328 30.6432 33.0053 1.46337 8.27478 -1.79938 -4950 6 41.0778 31.9114 16.1974 16.3032 -14.6541 -18.8682 -4951 4 41.8878 32.072 16.7344 -12.1593 -9.44827 -16.6375 -4952 4 41.2894 31.3264 15.4036 6.53327 16.9697 25.199 -4953 6 31.7476 18.8699 19.3483 9.2825 22.1595 5.37598 -4954 4 32.0642 19.7361 19.7036 -9.20895 -19.367 -8.68372 -4955 4 31.4026 18.3831 20.1168 1.10858 -0.37958 -4.48043 -4956 6 10.4875 4.12209 19.3444 6.70816 11.4672 -10.0773 -4957 4 9.70261 4.48263 18.8666 20.7562 -4.21822 -0.723312 -4958 4 11.3166 4.33216 18.8218 -27.5212 -3.06207 15.0001 -4959 6 1.37991 32.4635 19.2846 24.7257 -29.6508 -15.3303 -4960 4 1.97113 31.6954 19.1311 -3.90248 7.07021 19.3035 -4961 4 1.16609 32.6455 18.3731 -9.24935 13.5936 -9.63824 -4962 6 42.8716 16.8513 24.9892 37.8526 -21.8211 -51.5646 -4963 4 42.4398 17.6894 25.0051 -12.6784 17.6471 3.13223 -4964 4 43.4179 16.871 24.1222 -26.4831 0.994324 39.976 -4965 6 45.3183 19.1979 4.10041 6.37956 15.045 3.35342 -4966 4 46.1127 19.7887 4.04575 -15.2131 -7.48775 2.85843 -4967 4 44.6191 19.6898 4.58798 10.0124 -1.75765 -5.61527 -4968 6 29.1291 19.8804 35.7574 13.154 -41.1853 -12.3735 -4969 4 28.6049 20.2559 36.4387 -19.4183 16.2678 16.1743 -4970 4 29.3151 20.5439 35.0927 -1.78114 11.3903 -2.63997 -4971 6 31.9353 21.8377 19.6787 8.2762 14.7684 -3.54893 -4972 4 32.7301 21.8918 19.0885 -22.5823 -4.29925 15.9785 -4973 4 31.6692 22.7774 19.8195 3.83825 -20.8185 -1.08359 -4974 6 39.1936 8.26228 18.8336 -23.7578 16.4079 -2.4793 -4975 4 38.9784 7.343 18.63 -1.41923 -3.63173 -0.882922 -4976 4 38.3593 8.77699 18.6285 24.7505 -17.6369 4.60834 -4977 6 33.27 13.2649 41.2621 -10.1289 -28.0457 11.6457 -4978 4 32.3532 13.5818 41.1472 2.43324 -1.71459 -0.314725 -4979 4 33.2053 12.355 41.6729 1.3348 20.3333 -9.56947 -4980 6 5.93721 29.5458 35.7995 -7.4397 -15.3695 -5.23966 -4981 4 6.3797 30.3135 36.1022 6.42857 23.5026 12.0451 -4982 4 6.51225 29.246 35.0987 1.02237 -6.8727 -9.18458 -4983 6 13.023 34.1764 31.9266 -10.1581 -4.84889 27.419 -4984 4 13.003 33.3874 31.3637 -4.82745 -5.23795 6.11925 -4985 4 12.6053 33.9771 32.8123 10.4055 -1.49763 -26.3146 -4986 6 33.9757 21.8032 17.9969 16.1152 -19.1834 -4.43927 -4987 4 34.6651 21.0941 18.0436 -13.0194 10.1005 -1.31384 -4988 4 34.4424 22.6001 17.7557 11.611 10.6919 -5.33679 -4989 6 35.9777 41.3398 18.1614 -6.56463 -6.11943 -26.9477 -4990 4 35.8856 41.423 17.1648 6.35377 -3.40276 32.4743 -4991 4 36.5823 0.128109 18.4064 3.22136 6.47441 1.04719 -4992 6 34.856 37.6452 30.5972 -0.647303 3.94572 7.36538 -4993 4 35.2577 36.9607 30.0196 0.445186 1.06156 15.4535 -4994 4 34.8848 37.3986 31.5588 5.49281 -5.52744 -23.9922 -4995 6 25.9972 34.4216 4.68589 -10.7784 -9.94602 -21.2075 -4996 4 25.3582 34.53 5.39473 2.66172 5.48603 12.8385 -4997 4 26.8259 34.8497 4.89674 4.47855 8.12742 13.9663 -4998 6 19.0606 33.5662 1.31783 4.31184 23.0948 -29.5486 -4999 4 19.7493 33.0549 1.74461 7.17592 -5.61608 3.87291 -5000 4 19.5019 34.1007 0.592753 -8.94353 -18.7796 23.9626 -5001 6 25.2721 8.22916 8.60038 8.3672 -6.50911 13.4278 -5002 4 25.4774 8.1828 9.55838 -2.37789 7.03817 -10.0574 -5003 4 25.4001 9.14285 8.30246 -0.229164 -0.61302 1.82749 -5004 6 12.8408 19.6874 13.0432 23.1779 -10.767 -3.57874 -5005 4 11.9236 19.9359 13.0109 -16.1394 8.08564 -1.3752 -5006 4 13.3549 20.4875 12.8299 -11.6819 -5.55115 1.76181 -5007 6 53.3458 11.4322 5.81729 13.7919 -26.0181 10.511 -5008 4 53.941 11.999 6.3288 -5.2171 7.54934 -1.97002 -5009 4 52.6156 11.905 5.44666 -11.025 16.6744 -4.72885 -5010 6 9.84401 16.0447 31.1965 1.52473 25.7097 1.4485 -5011 4 9.0725 15.75 30.7245 -12.2986 -10.5074 -10.4763 -5012 4 9.76401 17.0228 31.1974 4.09395 -10.8484 3.46066 -5013 6 25.4337 20.2897 3.31222 -0.0744965 -16.6885 15.2888 -5014 4 25.4502 20.7681 4.1742 1.29774 3.58896 -22.0188 -5015 4 25.617 20.9088 2.59036 0.892976 4.59184 10.0233 -5016 6 20.7687 8.19442 15.6442 -13.8219 -45.5838 -0.24202 -5017 4 20.3131 8.5145 16.4113 -6.16339 18.6345 13.1662 -5018 4 20.3525 7.29833 15.5772 17.5129 18.5489 -8.91575 -5019 6 37.6537 8.61162 9.99803 6.38032 -10.5281 17.8344 -5020 4 37.9174 7.70722 10.2264 -2.01487 8.44182 4.78342 -5021 4 37.3414 8.51532 9.10193 -3.86116 3.7435 -6.65528 -5022 6 50.6588 4.51187 24.2729 -10.1552 -3.70856 6.87258 -5023 4 49.9071 3.88527 24.1971 13.583 4.61791 0.248303 -5024 4 51.4381 4.036 24.5943 -3.42543 -3.47462 2.6777 -5025 6 20.1632 24.8244 34.8962 -12.0105 28.899 -22.2545 -5026 4 19.9486 25.4522 34.1467 5.29317 -18.0262 19.0072 -5027 4 20.331 23.9626 34.5117 -0.31696 -10.3492 -2.27521 -5028 6 30.5785 22.522 11.2467 -2.76969 13.8933 23.9619 -5029 4 31.2526 22.1243 10.7257 13.2932 -13.8734 -17.1472 -5030 4 31.019 23.338 11.5119 -11.6942 5.7798 2.38886 -5031 6 17.322 40.803 8.03266 14.2969 -15.2802 9.14469 -5032 4 17.3696 39.9923 8.55945 -20.3131 5.85274 7.92005 -5033 4 18.1352 40.6655 7.5489 4.4024 9.10004 -19.1526 -5034 6 23.9661 41.0457 26.0803 21.1205 -0.428792 10.5169 -5035 4 24.3123 40.6207 25.2948 17.4674 -5.32369 -4.96192 -5036 4 23.0464 41.0448 25.8953 -36.0489 4.67224 4.09659 -5037 6 9.79449 25.5813 27.216 11.7002 -20.4303 -20.1428 -5038 4 10.1564 25.0129 26.491 -8.57195 17.3601 17.171 -5039 4 10.1924 25.2359 28.0288 -3.53182 0.239058 0.558234 -5040 6 35.2535 29.8267 24.7533 16.8399 6.514 6.92542 -5041 4 34.3962 29.6585 24.3475 -6.29365 6.70405 -5.90439 -5042 4 35.51 30.7547 24.57 -10.2352 -8.20594 -2.77553 -5043 6 2.14051 4.25227 10.5512 -4.35014 2.09559 7.87868 -5044 4 1.87018 4.24401 11.51 4.03105 2.56783 -22.6964 -5045 4 1.48695 4.75313 10.0317 0.0426026 -1.98947 12.7879 -5046 6 43.1755 3.92129 23.5016 -16.6861 -14.9885 0.818311 -5047 4 43.8939 4.14262 22.9078 7.68421 2.83398 -7.81803 -5048 4 42.5577 3.34913 22.9937 11.3891 7.34243 2.48813 -5049 6 18.8996 22.6297 2.43765 22.7339 -13.1014 -2.24121 -5050 4 19.79 22.181 2.40524 -25.7911 11.1615 4.63986 -5051 4 18.7139 22.8085 3.37028 4.18935 -2.21949 -1.21374 -5052 6 20.4908 18.9405 41.5599 0.284845 -17.4141 21.8797 -5053 4 20.1374 18.6064 0.533469 2.69626 22.1818 -33.2143 -5054 4 19.9839 19.6587 41.147 -4.56676 -6.01516 12.1125 -5055 6 26.4163 7.55623 29.1338 1.47231 -3.25042 -11.8229 -5056 4 25.7099 7.08251 28.6481 8.40182 7.03804 13.9135 -5057 4 27.0821 7.71224 28.4448 -4.02075 -2.1597 11.7889 -5058 6 25.6465 35.5679 33.7595 -11.9902 -19.4032 2.16293 -5059 4 26.3374 36.2384 33.6103 2.60319 -14.9989 -6.30077 -5060 4 25.8315 34.6987 33.2841 2.54327 33.8846 12.2934 -5061 6 24.8333 0.493635 8.41989 34.5336 11.5552 47.2955 -5062 4 25.5249 0.302877 9.1499 -35.8013 6.01564 -39.2036 -5063 4 24.7614 41.6068 7.91956 0.436288 -16.6888 -13.1367 -5064 6 17.008 17.3182 3.45493 -26.2706 15.7324 15.4846 -5065 4 16.2426 17.9829 3.53843 29.8189 -30.5055 4.13684 -5066 4 17.1653 16.9244 4.35506 -11.2277 16.1793 -19.3505 -5067 6 40.1827 32.1035 19.3506 13.0539 -5.95213 0.358733 -5068 4 39.8335 31.2604 19.604 -25.4023 -11.2285 12.0125 -5069 4 40.9513 31.7409 18.9215 18.5667 14.352 -9.19942 -5070 6 23.3808 26.7171 6.31746 29.0762 21.4976 14.3842 -5071 4 24.13 27.3908 6.46801 -30.1018 -19.5893 -7.69607 -5072 4 22.7349 27.0723 5.68536 3.11778 6.18165 -0.6273 -5073 6 28.6527 28.5112 1.41186 -10.6623 -30.4119 4.69741 -5074 4 28.683 29.4458 1.20631 15.125 4.74584 -7.70298 -5075 4 29.5288 28.0803 1.2704 -12.115 26.7011 1.44139 -5076 6 12.0438 6.3157 14.0384 -8.70244 -3.06108 -4.52058 -5077 4 11.2798 6.1721 13.4181 27.4537 -0.215786 8.28745 -5078 4 12.8925 6.19521 13.5554 -16.057 2.9292 1.41242 -5079 6 20.1243 33.7022 32.0954 -30.4257 7.53408 -8.19993 -5080 4 20.1371 33.1054 32.8412 7.6416 -5.80656 10.7415 -5081 4 21.0197 33.8732 31.8382 18.9224 -1.8204 -0.321518 -5082 6 12.0625 33.3632 34.5388 -0.325915 -41.4281 -23.9157 -5083 4 11.5602 33.8727 35.1697 -10.674 0.646784 10.687 -5084 4 11.6234 32.4653 34.3673 14.5179 34.5198 8.14895 -5085 6 6.00279 22.2605 25.0501 2.06163 -11.5991 79.3474 -5086 4 5.88194 22.3996 24.153 -16.4068 14.8809 -57.8418 -5087 4 5.25089 22.6367 25.5854 16.5977 -6.05374 -22.2773 -5088 6 28.8802 9.48792 11.0269 30.0757 -27.8021 5.60101 -5089 4 29.142 10.167 11.6644 -15.2392 1.2069 -12.766 -5090 4 28.0854 9.70897 10.5587 -15.7703 15.13 -3.00542 -5091 6 25.9783 31.1564 24.8742 0.212243 -23.2246 11.0271 -5092 4 26.2703 31.9474 24.4305 5.78101 9.73635 -10.8861 -5093 4 26.5948 30.4205 24.6499 -9.08002 14.2421 1.82694 -5094 6 17.4069 22.6321 26.9528 -11.8732 29.0046 13.506 -5095 4 17.1509 23.4374 27.5137 11.798 -28.7792 -23.9739 -5096 4 17.5283 21.9112 27.5803 0.671776 -8.09241 2.21186 -5097 6 30.9731 17.6144 1.64569 13.582 26.8251 31.1357 -5098 4 30.2123 17.6859 1.07719 -13.0538 -2.75682 -13.3747 -5099 4 31.0067 18.4528 2.19078 1.05257 -25.2161 -14.5596 -5100 6 35.2833 9.73343 11.2271 -16.277 -4.62114 -26.0747 -5101 4 34.627 9.45499 10.5137 29.3374 5.62349 25.4867 -5102 4 36.1567 9.37366 10.9701 -6.28276 0.375521 -3.01301 -5103 6 12.0057 10.8077 4.27601 -12.2512 -1.40581 -7.43609 -5104 4 11.4458 10.5898 5.05281 2.39288 0.24657 -15.6405 -5105 4 11.51 10.5288 3.46435 7.55978 2.35404 20.8087 -5106 6 52.9546 23.1284 7.66438 3.19212 11.9041 -9.13647 -5107 4 53.8155 23.0936 7.22037 1.72331 -6.21969 -0.472682 -5108 4 52.7997 24.0739 7.82392 -0.633169 -8.94194 3.43433 -5109 6 27.374 5.80114 23.1096 7.51778 12.7335 11.6917 -5110 4 28.1753 5.52132 23.6349 -22.415 18.9583 -13.4562 -5111 4 27.3645 6.79042 22.9959 5.3793 -33.2455 5.89418 -5112 6 22.7689 37.6996 15.5372 -5.91943 -7.67105 33.7333 -5113 4 22.8436 37.842 14.6084 2.14719 5.97904 -25.5056 -5114 4 23.2999 36.9284 15.7907 -0.822855 1.46565 -2.93441 -5115 6 30.5901 30.1355 39.7465 -8.92084 9.99629 -19.6672 -5116 4 30.0839 29.6315 39.0953 -1.54922 -9.94816 6.16305 -5117 4 30.5761 31.0154 39.3281 8.00114 -4.73058 9.29019 -5118 6 26.5152 14.8694 29.9646 3.93344 -0.205179 -3.29595 -5119 4 25.7559 15.3094 30.3103 -24.5604 12.1261 -1.41502 -5120 4 27.0839 14.9289 30.718 22.1413 -5.57177 12.178 -5121 6 9.52543 19.5487 37.4182 -4.93509 -3.75546 7.04348 -5122 4 8.56858 19.5373 37.6772 20.7537 10.8584 -9.00922 -5123 4 9.7741 20.4052 37.0166 -14.5013 -9.56436 9.93265 -5124 6 0.91928 14.8658 2.69601 -17.5095 9.99019 63.3715 -5125 4 1.47581 15.1737 2.02419 28.2707 8.36374 -43.6031 -5126 4 1.18821 15.4309 3.47389 -7.04008 -21.0896 -18.5042 -5127 6 46.427 27.1287 41.5945 43.2461 -1.33556 -25.8044 -5128 4 47.402 27.2052 41.2817 -46.4011 -2.64418 15.4668 -5129 4 46.0299 26.5803 40.8989 0.996959 5.24299 8.87294 -5130 6 47.678 23.0562 21.3872 5.44089 38.3346 6.01366 -5131 4 46.9403 23.2179 20.8133 -13.997 9.90145 -6.64011 -5132 4 47.7418 22.1285 21.385 8.56341 -43.7487 4.99103 -5133 6 39.8587 22.235 3.08723 2.37939 -15.5871 -9.21378 -5134 4 39.0088 22.2526 3.53641 -4.44104 7.43329 4.08383 -5135 4 39.9535 21.2857 2.86173 -0.917299 22.2801 6.61021 -5136 6 14.9853 14.9328 33.4647 9.90785 18.6887 5.96998 -5137 4 15.4024 15.8269 33.5858 -13.0369 -24.3412 -0.758701 -5138 4 14.5599 14.6915 34.3048 3.28451 6.61064 -6.43534 -5139 6 27.3302 11.4834 31.9317 -27.4366 -15.9755 21.8219 -5140 4 26.9982 12.0952 32.5883 -9.79098 -5.70708 8.51591 -5141 4 28.0752 11.9422 31.6406 46.9031 18.536 -28.2392 -5142 6 36.7579 7.97089 7.62034 -1.24967 -18.9477 -14.6485 -5143 4 35.954 7.42009 7.70022 6.4697 6.94413 -3.0671 -5144 4 37.4142 7.36122 7.22008 -3.07725 6.9494 1.66736 -5145 6 49.4451 9.66335 18.2174 -4.20907 -17.0946 -5.32386 -5146 4 50.1075 10.0642 17.6138 -11.2883 10.4151 20.0604 -5147 4 49.0937 10.2089 18.9473 16.8995 10.9543 -13.1485 -5148 6 27.0353 33.866 10.7555 -3.61813 20.4819 39.0174 -5149 4 27.1089 33.3944 9.9425 -11.0368 -7.55411 -28.9907 -5150 4 26.1735 34.332 10.8422 4.28798 -12.7598 -13.2634 -5151 6 11.1949 37.4624 6.84871 0.36549 -16.8746 15.3404 -5152 4 10.8648 38.3395 6.66289 0.465253 11.7734 -2.90488 -5153 4 12.1583 37.5341 6.85599 1.64848 0.115814 -1.2743 -5154 6 19.2537 19.4156 21.9114 -15.7985 8.22585 33.6704 -5155 4 18.5515 19.3251 21.2863 -16.3583 -5.26309 -15.3133 -5156 4 20.0646 19.323 21.4355 25.7859 -3.53787 -14.4318 -5157 6 54.4972 2.91444 22.5674 41.6328 11.7794 25.4635 -5158 4 54.323 3.09449 21.6644 -16.7292 4.15243 -34.296 -5159 4 0.405558 3.31869 22.7045 -24.6299 -12.807 4.19326 -5160 6 45.0583 10.8549 24.2301 5.83399 20.0221 21.0618 -5161 4 44.4296 11.5751 24.1426 -7.03973 -3.51443 -9.4179 -5162 4 45.6095 11.2138 24.9523 4.1225 -19.1196 -10.3672 -5163 6 14.387 34.402 24.7643 -0.614961 -5.50567 -8.46915 -5164 4 14.802 35.2302 25.0278 -0.621724 2.17228 4.67692 -5165 4 14.8142 34.1913 23.9221 -0.527667 -3.77388 -2.27373 -5166 6 50.586 17.557 4.30707 17.1275 -18.9627 18.6811 -5167 4 51.3126 17.9927 4.759 8.45418 -3.82203 7.11351 -5168 4 50.1863 18.2804 3.88376 -26.598 27.5468 -24.7799 -5169 6 14.9317 33.3337 34.1113 -12.3404 20.8418 56.9019 -5170 4 15.0455 32.9404 33.2912 5.44957 -23.8922 -53.334 -5171 4 14.0148 33.1563 34.3942 8.12215 6.97131 -5.23034 -5172 6 20.8706 33.5768 38.9143 15.1188 7.04694 -15.6549 -5173 4 20.7999 34.008 39.7578 -2.44584 7.66125 17.1111 -5174 4 20.3826 32.7659 38.9944 -10.1095 -18.4284 -0.973943 -5175 6 7.78494 4.73961 26.7587 18.7098 -5.63937 13.378 -5176 4 7.2181 5.0845 27.4506 -5.7435 6.37459 2.19378 -5177 4 7.246 4.75931 25.9687 -5.82922 -1.99593 -5.70414 -5178 6 9.28281 21.4851 22.3014 51.087 14.0475 -25.6174 -5179 4 8.74732 21.9732 21.6886 -31.0609 5.1079 -5.58489 -5180 4 10.1706 21.7227 21.8793 -22.1752 -18.3044 28.8298 -5181 6 20.5441 38.2146 8.8638 -2.83914 11.917 26.817 -5182 4 20.3663 38.6401 9.7626 4.81036 -21.6973 -30.7816 -5183 4 20.4013 37.2533 8.94236 -1.07384 9.24152 7.62946 -5184 6 30.1053 39.0795 30.7451 -13.6764 41.2724 28.6819 -5185 4 30.3998 39.946 31.2193 -9.10868 -42.8123 -24.766 -5186 4 29.1169 39.0706 30.8728 28.3121 -0.882933 -5.94109 -5187 6 16.0486 22.0268 24.5039 34.2787 3.60452 0.906339 -5188 4 16.7735 22.0671 23.8432 -14.3833 -3.87047 -0.289875 -5189 4 16.5419 22.3002 25.3044 -14.2176 -3.36187 3.5873 -5190 6 5.74232 29.2062 14.4594 -18.34 10.8061 -32.1404 -5191 4 6.48422 28.7094 14.7814 11.5218 -3.49899 17.506 -5192 4 5.24211 29.6259 15.1721 5.10135 -5.91064 9.04276 -5193 6 28.0673 3.08827 25.2267 -6.08854 1.42804 12.0746 -5194 4 28.6661 3.71086 24.7756 -7.19123 -0.840207 10.3279 -5195 4 27.7106 3.5203 26.0449 13.0908 -0.523763 -20.3567 -5196 6 45.9319 29.2971 31.4223 -7.33073 21.7818 28.5056 -5197 4 45.7264 28.738 30.6765 -12.0419 -4.51403 -16.7723 -5198 4 45.1872 29.9464 31.611 20.2512 -24.9239 -13.0948 -5199 6 11.2178 22.8398 36.7928 3.83605 7.6889 -19.1741 -5200 4 10.7288 23.4227 36.1801 1.54849 -6.36416 6.79315 -5201 4 12.0227 22.5824 36.3 -5.92076 -0.954096 11.0422 -5202 6 18.9236 40.1387 39.9284 -8.72712 -15.4473 12.674 -5203 4 19.137 39.1923 39.9727 -1.01676 1.76774 -7.47997 -5204 4 18.926 40.4024 40.8597 -1.95632 5.76083 -1.10583 -5205 6 23.5567 26.0801 21.2876 -20.8354 -5.58511 20.4095 -5206 4 22.8283 26.6117 20.9473 7.44123 1.31497 -7.03875 -5207 4 23.1869 25.6705 22.0991 12.7429 3.57595 -14.6326 -5208 6 16.8309 5.38685 15.8596 17.5735 -24.6285 20.3591 -5209 4 16.4468 5.29371 14.9868 -10.6119 14.9975 -0.930521 -5210 4 16.6163 6.1995 16.3389 -7.69088 7.65746 -13.895 -5211 6 12.049 26.6129 14.9962 1.83385 5.07399 -16.0821 -5212 4 11.6864 25.936 15.5307 6.55853 -24.3886 27.1256 -5213 4 11.2609 26.839 14.5085 -0.894459 16.8406 -16.785 -5214 6 14.3334 41.4222 2.37421 26.0216 21.5484 -18.2857 -5215 4 13.7051 40.9662 2.90199 -22.7144 -12.1023 21.977 -5216 4 14.3738 0.426145 2.71152 -4.41702 -11.6567 2.07407 -5217 6 50.4009 35.8582 9.31454 24.1561 17.2373 -12.1424 -5218 4 50.8168 35.8748 8.42953 -10.1576 -5.67977 3.83986 -5219 4 50.8977 36.5714 9.7704 -11.7974 -14.2445 3.10197 -5220 6 11.3695 22.6672 26.8678 6.20997 3.92483 11.2558 -5221 4 12.2048 22.3333 26.5164 -4.88328 -1.76893 -0.685046 -5222 4 10.6892 22.391 26.2565 -8.40373 -4.36232 -8.95219 -5223 6 8.45148 34.5593 21.2814 -25.9919 -59.0281 13.1791 -5224 4 8.04792 35.0446 21.9998 -0.548909 12.0582 7.93151 -5225 4 8.02348 33.6171 21.3881 27.3669 48.26 -12.6189 -5226 6 9.41918 8.68911 24.4735 -32.1109 22.232 -11.1027 -5227 4 8.45415 8.80658 24.2608 22.5553 -3.45738 3.03744 -5228 4 9.54271 9.26889 25.2379 6.1219 4.18012 4.13063 -5229 6 32.6166 22.3351 34.507 3.90791 9.0503 -27.7323 -5230 4 32.5036 23.1955 34.0662 0.599489 -5.17288 -1.28756 -5231 4 32.8196 22.6091 35.3861 6.87298 3.84758 30.2519 -5232 6 26.7427 26.1702 7.11338 18.0622 8.0778 -11.4877 -5233 4 26.0574 25.7087 7.60312 -9.51312 -3.43645 7.19196 -5234 4 26.4504 27.0916 6.97179 -2.60416 -16.0173 4.37043 -5235 6 33.9976 11.9299 3.97475 -1.16308 1.75568 6.69865 -5236 4 33.7915 11.6388 4.87314 3.4696 4.99202 0.68255 -5237 4 33.8545 12.8906 3.99294 -0.306808 -3.71184 -1.40707 -5238 6 21.4819 20.9256 37.2108 -8.76322 20.972 13.918 -5239 4 22.36 21.3309 37.2026 5.25525 -6.97128 0.105034 -5240 4 21.5739 19.9858 37.0637 7.9716 -15.2147 -3.23728 -5241 6 18.467 41.0278 0.654954 -19.554 -29.5721 -12.8619 -5242 4 17.5024 41.1258 0.530294 8.77033 6.01734 2.0842 -5243 4 18.8042 41.8885 0.845086 4.40915 26.8371 2.49279 -5244 6 41.3548 41.7118 25.1844 12.9409 14.5374 -0.392323 -5245 4 40.9222 40.8883 25.4041 -6.90081 -12.2223 3.22908 -5246 4 41.5202 41.6634 24.2378 -1.56977 -0.361026 -1.444 -5247 6 27.6369 28.1312 3.93858 39.9773 31.9241 -60.8173 -5248 4 27.7577 28.1455 2.91253 -1.05119 3.80663 52.0412 -5249 4 26.945 27.5412 4.09124 -36.8498 -31.9254 8.70709 -5250 6 18.2839 10.5111 31.4966 0.533258 -0.0130678 0.979798 -5251 4 17.4029 10.1636 31.5665 -10.6602 -13.9647 -0.00296819 -5252 4 18.1106 11.4466 31.5267 10.9856 11.4938 1.12981 -5253 6 11.3036 37.9694 14.764 4.77413 -10.0896 11.5971 -5254 4 10.7874 37.239 14.4221 -9.53089 5.23111 -9.63971 -5255 4 11.7579 37.5414 15.5118 -2.30342 16.6377 -5.07599 -5256 6 0.816524 18.1414 27.5647 20.1272 -0.3628 -0.469578 -5257 4 0.17179 17.4415 27.469 -11.396 -5.37013 -1.78049 -5258 4 1.63281 17.6507 27.785 -7.45447 11.2502 -1.88757 -5259 6 36.8008 10.7378 20.295 8.4208 9.86458 8.47872 -5260 4 36.1948 10.0642 20.0001 -9.44027 -8.16387 -5.04241 -5261 4 36.5983 10.8279 21.2363 1.65531 0.40354 2.85938 -5262 6 47.4201 25.5213 8.04394 8.74054 5.57223 -13.14 -5263 4 47.3566 25.6372 7.0634 -2.71671 -4.96685 23.4826 -5264 4 46.5708 25.2582 8.40304 -6.39129 0.734124 -5.55138 -5265 6 13.9238 35.1275 16.0037 32.5083 18.1998 3.59786 -5266 4 13.2022 34.5755 16.1957 -32.489 -30.3694 18.6715 -5267 4 13.7597 35.4303 15.121 4.25156 9.41728 -20.5426 -5268 6 29.562 35.3734 16.1776 -35.0835 -2.07929 -8.00281 -5269 4 30.2224 34.9599 16.7245 13.9673 -5.91711 9.2078 -5270 4 28.7051 34.8863 16.2926 25.5199 12.926 -4.35301 -5271 6 29.4722 25.8866 32.4187 14.354 2.72026 -23.1845 -5272 4 28.9025 25.7608 33.1796 -14.4011 -9.23541 2.43376 -5273 4 29.1922 25.3818 31.6086 -3.9853 6.0929 23.1903 -5274 6 24.1343 2.13601 25.4438 45.8363 12.8335 -27.0328 -5275 4 24.6226 2.81425 24.8647 -23.4035 -21.9591 22.2831 -5276 4 24.7019 1.32842 25.3981 -18.0817 13.4017 1.18969 -5277 6 4.54354 34.4275 19.14 11.1292 -12.0398 21.377 -5278 4 4.4735 34.5954 18.1883 -15.738 1.03246 1.7136 -5279 4 3.71635 34.4131 19.6775 9.89222 2.06937 -18.6971 -5280 6 10.1248 17.2257 14.3121 -1.66581 -5.60367 -9.60454 -5281 4 10.2583 17.5937 15.1679 8.8306 2.43924 21.0325 -5282 4 9.4989 17.8227 13.9164 -6.75609 1.38519 -13.487 -5283 6 21.4392 41.7587 34.6855 22.2624 7.769 -11.2018 -5284 4 21.5032 41.1211 35.405 -13.4071 -7.19641 7.36579 -5285 4 20.544 -0.0182627 34.3462 -4.72666 -12.2957 11.4101 -5286 6 36.1543 24.108 12.5954 -4.82194 -9.49577 -8.67068 -5287 4 35.691 23.694 13.3698 5.25066 1.62288 -23.6525 -5288 4 35.776 23.8018 11.7194 2.97337 4.42231 26.8685 -5289 6 49.5838 18.601 19.9434 7.37368 0.836531 -4.03301 -5290 4 50.0063 19.3607 19.4891 -2.40205 -12.3461 5.19746 -5291 4 50.2865 17.9356 20.0577 -3.44895 8.52353 -2.14521 -5292 6 1.26001 7.05318 14.4907 38.3056 -26.8237 -27.7837 -5293 4 1.8201 6.82299 13.6677 -23.9217 11.4061 34.9177 -5294 4 1.48256 6.35829 15.148 -4.21477 12.5307 -9.57675 -5295 6 12.7431 22.7759 31.2417 -21.5742 -17.6245 -17.2109 -5296 4 12.7068 22.0167 30.6251 -0.189583 12.5272 11.0438 -5297 4 13.6543 23.0267 31.2833 20.8009 4.17698 1.04357 -5298 6 8.18693 18.6259 27.8062 12.2535 -2.56913 -7.18349 -5299 4 8.40416 17.6764 27.919 2.05523 15.8207 -2.89848 -5300 4 8.90605 19.0032 27.258 -7.77238 -10.2714 7.52916 -5301 6 52.132 28.0244 15.3085 -5.0475 -8.46487 8.97907 -5302 4 52.2845 27.4141 14.5747 1.7297 4.34316 -0.517396 -5303 4 52.1194 28.9169 14.9336 2.1814 -6.82244 -4.33507 -5304 6 52.6909 21.916 10.0977 -8.33066 3.09691 2.06611 -5305 4 53.4463 22.3007 10.5387 10.5159 5.84972 4.87058 -5306 4 52.7807 22.2562 9.19728 -3.40401 -0.944397 -1.81328 -5307 6 22.3502 5.78024 2.67711 -1.19821 4.70475 8.9403 -5308 4 22.3462 5.61537 3.63751 1.98719 -8.03511 -7.01348 -5309 4 22.5962 4.95479 2.25163 2.53332 -12.0932 -0.158426 -5310 6 15.4205 16.2192 21.8867 5.02822 24.0999 -40.4778 -5311 4 14.4784 16.2102 22.0595 -10.022 -3.20892 10.2198 -5312 4 15.4767 16.6809 20.9929 2.09736 -16.6333 30.6862 -5313 6 28.7089 41.2927 33.91 5.52796 3.54283 5.25404 -5314 4 28.727 40.4953 34.4564 -2.79359 -2.24742 -0.170863 -5315 4 27.7951 41.4466 33.6263 4.57527 -2.88437 3.84631 -5316 6 9.01739 31.2727 18.2059 -18.1749 -3.84142 11.7815 -5317 4 8.98151 32.2312 18.3694 0.025829 -3.44513 1.18933 -5318 4 8.52849 30.7949 18.9304 13.8496 11.5721 -17.6376 -5319 6 20.5529 20.3981 18.1799 -10.2473 -3.12886 -8.71499 -5320 4 21.0329 20.6151 18.9854 0.125323 4.65459 7.73128 -5321 4 19.8496 21.0773 18.075 13.4895 -10.4913 3.92819 -5322 6 53.9703 14.7072 37.8312 5.01214 -4.5628 8.74013 -5323 4 53.4666 15.4974 37.9319 -5.56379 24.6001 14.4542 -5324 4 53.6093 14.375 37.0321 1.20033 -18.5897 -21.23 -5325 6 28.9035 15.3885 18.8586 45.4636 -15.1916 -0.680493 -5326 4 29.8469 15.0873 18.5932 -41.6456 12.1347 6.71251 -5327 4 28.9115 15.3505 19.8299 -3.5302 1.25595 -2.12016 -5328 6 2.00256 25.8212 18.9096 3.72723 11.471 14.7099 -5329 4 2.26458 26.6216 18.4327 2.14682 1.88771 -0.892997 -5330 4 1.76414 25.179 18.2501 -5.23937 -11.562 -15.1322 -5331 6 53.2507 40.704 24.2965 8.91441 12.4597 1.37217 -5332 4 53.4683 39.7911 24.0958 -2.511 -10.6834 -0.444896 -5333 4 54.079 41.1598 24.0633 -8.96863 1.63956 3.52407 -5334 6 47.5231 32.0042 22.8531 -14.3462 4.46803 -6.08063 -5335 4 47.3408 32.7709 23.4273 6.00779 -4.56073 2.25025 -5336 4 48.2766 31.5253 23.2067 4.67997 4.39959 7.43042 -5337 6 24.6197 26.1463 33.0089 -12.4366 -5.18424 3.68853 -5338 4 24.4183 25.6868 33.835 -4.3875 -0.159577 -1.83724 -5339 4 25.4547 26.5812 33.1385 10.0429 5.3772 -3.83199 -5340 6 21.3442 17.0884 39.4824 -9.75867 4.42788 -12.86 -5341 4 22.0786 16.6105 39.8509 9.0034 -0.419098 8.66004 -5342 4 20.9617 17.649 40.1682 3.71874 -0.284678 5.70811 -5343 6 11.0324 40.4486 17.0358 15.7971 -30.8577 -26.0801 -5344 4 11.6842 41.1185 17.2103 4.65986 12.9737 2.4903 -5345 4 11.491 39.8695 16.3608 -26.1319 15.9634 25.4848 -5346 6 20.3416 21.2702 39.8615 -24.9835 10.9638 22.3655 -5347 4 20.689 20.9793 39.0389 13.9219 -9.37305 -28.7546 -5348 4 21.0638 21.2843 40.4958 4.25493 1.29328 -0.298347 -5349 6 2.11091 29.6941 22.5934 -5.9509 -23.8702 -11.6938 -5350 4 1.45034 28.9715 22.5035 1.67869 13.3355 3.97539 -5351 4 2.94117 29.2559 22.3631 0.0654014 9.01208 -1.60678 -5352 6 36.7558 30.2897 35.4506 24.3729 -18.3256 16.5828 -5353 4 36.1768 30.1398 36.2224 6.47664 5.98183 -7.75951 -5354 4 37.6324 29.8684 35.7011 -26.9845 14.5763 -5.36474 -5355 6 12.9471 4.31284 37.9204 -6.90268 -11.166 6.10722 -5356 4 12.3078 3.59731 38.1765 12.7034 25.1114 3.17689 -5357 4 12.7446 5.19856 38.3152 -2.40344 -19.0082 -2.01981 -5358 6 38.3332 5.26794 18.4655 -19.3496 19.9027 -29.1997 -5359 4 37.4721 5.17942 18.8804 2.72791 -1.29988 8.64573 -5360 4 39.0241 5.01488 19.0552 15.587 -10.1496 24.0772 -5361 6 10.4858 9.23289 21.7404 -25.2332 -4.10139 2.16313 -5362 4 10.1465 9.25623 22.657 12.6022 -3.18555 -3.91704 -5363 4 11.447 9.27854 21.7188 5.40032 0.87934 7.2107 -5364 6 0.505771 41.0407 17.3245 -0.427706 37.3637 0.906459 -5365 4 1.03474 40.3115 17.5973 10.8601 -24.0642 8.3812 -5366 4 1.07952 41.8285 17.484 -10.202 -14.0113 -5.73388 -5367 6 4.10283 5.07754 6.43738 -38.2782 -14.6693 -26.7901 -5368 4 4.80956 4.44559 6.48511 17.8781 -6.62955 4.00539 -5369 4 4.33824 5.81877 6.9517 16.1672 26.1823 21.8329 -5370 6 11.4353 25.4218 0.164599 -6.84764 4.42394 -1.26617 -5371 4 11.3082 26.3017 0.56247 4.23965 -3.25035 1.30302 -5372 4 12.32 25.1006 0.40702 -4.64442 7.63092 -0.276853 -5373 6 7.41885 21.5502 8.10769 10.495 -13.722 -26.2993 -5374 4 7.61759 21.2522 7.17802 -11.0567 9.56016 28.8323 -5375 4 8.26229 21.8826 8.44859 -7.90548 -1.09713 -4.6635 -5376 6 47.5869 16.3678 25.2584 -15.0789 15.5873 -32.807 -5377 4 46.6352 16.1327 25.0388 32.9447 8.00435 6.4503 -5378 4 47.9767 16.8704 24.4584 -11.2605 -20.3751 33.7323 -5379 6 30.9209 19.4939 39.8451 -11.8548 28.7526 -24.1689 -5380 4 31.8555 19.5183 40.0202 17.1254 -10.6903 10.4692 -5381 4 30.8076 20.3562 39.3598 -8.87252 -26.4956 11.5622 -5382 6 20.3775 24.0331 39.393 16.2123 32.2964 -6.62361 -5383 4 19.46 24.2872 39.3788 -17.3162 -0.971439 2.40317 -5384 4 20.4139 23.0995 39.5119 -7.32592 -29.4126 2.4841 -5385 6 45.906 21.2665 41.1719 -24.2736 -11.4825 -0.885762 -5386 4 46.5804 21.1569 41.8486 15.7955 10.6383 -1.5802 -5387 4 46.0859 21.9477 40.5132 15.7742 6.36757 6.57249 -5388 6 32.5682 28.1996 30.46 3.6658 -10.99 6.0107 -5389 4 32.938 27.299 30.6104 -6.7941 21.8776 -2.09353 -5390 4 33.2105 28.8285 30.8344 -2.85996 -8.65293 -4.24176 -5391 6 18.0144 1.30598 27.0418 -16.6632 -1.71712 -0.445992 -5392 4 17.1007 1.69106 27.0468 26.0213 -5.17059 4.63351 -5393 4 18.4653 1.60291 27.8546 -9.34219 2.14994 -8.02835 -5394 6 39.3706 24.9704 21.8707 -3.8719 -7.6304 -3.05608 -5395 4 39.4638 25.9303 22.0078 -2.06007 -5.24545 2.56571 -5396 4 38.5004 24.7369 22.2528 8.08795 9.92494 -4.1564 -5397 6 33.5838 21.3134 22.0984 8.18441 -4.13225 6.82001 -5398 4 32.7138 21.3502 21.682 2.4933 6.37883 -5.99313 -5399 4 34.1113 22.092 21.8324 -12.1677 -4.37971 -1.53996 -5400 6 40.113 14.9986 15.7558 -14.3933 -54.3129 -47.4443 -5401 4 39.335 14.6192 15.2293 31.4969 18.6384 20.9479 -5402 4 39.7901 15.7154 16.2477 -17.7573 36.9578 24.811 -5403 6 32.6916 17.9228 6.36161 -9.89813 9.73379 -21.0853 -5404 4 32.6423 17.3002 7.0662 1.70901 -17.6566 26.5232 -5405 4 32.2464 17.4542 5.63975 -0.790726 3.03073 -5.51736 -5406 6 50.4678 15.9334 31.144 -39.7004 -26.5385 31.9374 -5407 4 51.253 16.1743 30.7093 39.9028 11.8107 -24.2063 -5408 4 50.5343 14.9829 31.3801 -1.18751 16.0768 -7.78774 -5409 6 23.825 29.3336 31.6412 17.8706 -6.79638 -8.14744 -5410 4 23.7507 29.695 30.7549 -4.03414 2.57591 0.878238 -5411 4 24.7016 28.8907 31.6365 -14.4802 6.46497 6.02506 -5412 6 25.0497 41.6479 38.28 3.49637 2.98657 -6.73496 -5413 4 25.6848 41.2957 37.6072 -14.3525 10.6226 12.6055 -5414 4 24.5759 0.544247 37.957 10.7828 -14.7666 -1.7986 -5415 6 14.3338 25.4719 8.00129 -34.0608 -17.9542 9.33499 -5416 4 15.0375 25.807 7.49197 32.7442 17.1809 -19.3974 -5417 4 13.7504 25.049 7.33286 9.67269 6.09785 11.4563 -5418 6 17.2157 20.7463 5.33337 -33.6161 12.1619 46.6806 -5419 4 17.4746 20.2104 4.61987 19.6997 -12.8632 -39.6831 -5420 4 17.6039 21.6267 5.33982 9.69266 2.06371 -12.0346 -5421 6 18.8632 10.9532 23.7128 -6.45661 -28.7698 -18.1749 -5422 4 18.5024 10.4645 22.9505 4.54871 -4.25462 9.96764 -5423 4 18.7195 11.8343 23.4273 2.43458 32.1183 3.28403 -5424 6 7.79185 41.3929 11.0465 3.42517 6.73563 9.75028 -5425 4 8.03468 40.5075 11.3396 -5.29569 0.405018 -3.04036 -5426 4 8.54504 0.0288503 11.3371 -5.83581 0.184768 -2.76634 -5427 6 48.7029 23.1861 34.0656 -21.7207 -4.36764 -18.9996 -5428 4 48.0685 22.9631 33.3267 17.6914 7.49561 22.5851 -5429 4 49.5647 23.2306 33.645 9.38657 -0.0360042 -3.96825 -5430 6 53.7171 23.5593 15.3279 7.98903 18.1369 9.52531 -5431 4 53.9889 24.0987 14.5512 -16.5338 -16.4319 -0.0123194 -5432 4 53.1679 22.8017 15.1046 0.0193492 2.24596 -12.2178 -5433 6 22.2331 5.62812 9.84443 -1.57081 2.06392 2.32933 -5434 4 21.8309 4.81719 9.48029 9.17546 11.008 0.0652314 -5435 4 22.6135 6.1669 9.11622 -10.9942 -17.7486 8.8339 -5436 6 33.6597 8.39756 9.07438 12.888 -3.30103 7.28088 -5437 4 32.9598 8.97334 9.38893 -12.3292 7.33717 0.65351 -5438 4 33.4682 8.16911 8.16186 -5.09418 6.09353 -6.44604 -5439 6 47.3119 37.7194 20.3363 21.5156 22.744 3.03657 -5440 4 47.6473 37.5407 19.4464 -9.46862 -8.33692 4.35957 -5441 4 46.6883 37.0359 20.5464 -12.6113 -19.4741 -3.99141 -5442 6 30.8566 16.7294 10.6197 -45.1927 -36.7422 15.3603 -5443 4 30.4293 17.2093 11.3782 10.0419 -7.15869 -15.9692 -5444 4 30.3248 15.8445 10.5087 28.8517 44.18 3.4025 -5445 6 48.1145 27.7388 10.1259 3.61398 12.7601 13.975 -5446 4 49.0121 27.5791 10.4269 8.16567 7.74751 7.8449 -5447 4 47.9875 27.049 9.49259 -14.0608 -13.1923 -17.2023 -5448 6 27.3333 38.6223 25.6028 2.23096 -19.4823 3.9502 -5449 4 28.2552 38.3493 25.5855 1.31221 -11.4567 4.08925 -5450 4 27.4115 39.4856 25.2253 -6.51803 21.9055 -3.11379 -5451 6 33.3641 5.73966 21.4502 -17.8674 16.1521 -18.7045 -5452 4 32.7333 6.1391 20.8022 11.3762 -13.0233 18.1576 -5453 4 34.2053 6.04196 21.1266 17.0109 2.35293 -3.511 -5454 6 25.3113 5.14231 4.52483 0.627568 -0.448638 -4.7772 -5455 4 25.9311 5.01166 5.26368 -5.83567 -1.85096 0.781095 -5456 4 24.4169 4.85751 4.79359 12.9854 0.158453 3.02285 -5457 6 40.4761 35.641 19.148 -1.79116 -1.08437 4.96155 -5458 4 40.617 35.2798 20.0294 1.97887 -12.6912 2.42284 -5459 4 40.4316 36.5735 19.3404 -1.08207 12.5153 -8.94186 -5460 6 49.6577 30.6259 19.0198 10.1565 -2.14928 -32.2041 -5461 4 49.9169 29.8714 18.4657 1.24638 0.0316256 -4.24874 -5462 4 49.4705 30.2089 19.8368 -7.31172 -12.6811 36.7039 -5463 6 42.1447 28.3235 17.0346 32.2065 -21.7575 -5.76428 -5464 4 41.8825 28.1658 16.1189 -9.06503 7.62036 -2.3435 -5465 4 42.9622 27.7534 17.0825 -24.1402 18.2728 2.552 -5466 6 47.7039 24.5139 36.3396 16.4403 6.39896 -6.79461 -5467 4 46.9537 23.9582 36.5487 -4.01092 -10.0931 -4.11437 -5468 4 48.0889 24.2445 35.4833 -10.0455 -7.86437 4.89019 -5469 6 19.3463 26.9837 19.8062 -14.9609 -0.640093 12.1457 -5470 4 19.5138 26.0435 19.7544 7.81166 -12.6546 -12.1749 -5471 4 18.7209 27.0489 20.5386 2.91516 7.38851 -4.99075 -5472 6 47.0534 26.8134 37.524 14.5946 -27.4581 20.3182 -5473 4 46.5999 27.4025 36.9765 -27.9132 42.868 -22.1392 -5474 4 47.3287 26.1433 36.896 5.92816 -9.16339 3.59921 -5475 6 9.30604 24.6864 40.2824 32.5721 -4.72803 4.84631 -5476 4 9.7425 23.8424 39.9878 -14.1318 19.2209 8.44319 -5477 4 10.0514 25.1942 40.7028 -19.8613 -12.5192 -10.8686 -5478 6 14.4861 17.9115 14.2864 12.9549 -2.10551 -8.28408 -5479 4 13.7677 18.2592 13.7435 1.92348 1.2648 2.86628 -5480 4 15.2633 17.8567 13.6783 -18.4643 2.67645 15.1406 -5481 6 37.1346 38.6824 18.7128 7.24689 -5.58535 -9.53541 -5482 4 36.7159 39.5508 18.578 6.84706 -0.690413 -9.37485 -5483 4 37.7177 38.457 17.9456 -10.6272 10.0511 7.65618 -5484 6 11.4119 5.91281 21.4549 8.51563 -6.63227 17.2429 -5485 4 12.0074 5.45436 22.0841 -12.0343 5.82261 -11.8758 -5486 4 10.9825 5.24051 20.9122 -1.087 -4.70833 -2.40093 -5487 6 4.25375 30.708 16.2346 29.3973 -34.9884 0.269827 -5488 4 4.09384 31.4404 15.6668 -11.3131 25.7038 -10.6546 -5489 4 3.7498 30.7826 17.0293 -13.4231 7.50595 13.7704 -5490 6 17.6719 16.0027 27.067 -23.8279 -26.0778 -36.6424 -5491 4 17.4271 15.046 26.968 10.0078 22.1048 9.82572 -5492 4 17.2008 16.3672 26.2667 15.5193 1.39518 21.9495 -5493 6 36.5109 8.65039 40.4308 12.8187 7.82554 4.51092 -5494 4 36.6212 9.57953 40.6523 1.70353 1.63484 0.0365135 -5495 4 35.6422 8.38915 40.7323 -7.59123 -4.26386 -1.28756 -5496 6 13.6114 12.9582 3.02589 -9.62347 -2.84414 10.0553 -5497 4 13.2363 12.4097 3.76862 19.3807 16.1747 -17.4749 -5498 4 14.4444 13.4268 3.2396 -7.87441 -9.64772 8.81761 -5499 6 38.5595 20.1494 21.6232 12.4359 -2.6335 16.4863 -5500 4 39.2259 20.3435 20.9591 -1.48691 0.443177 -6.45697 -5501 4 37.7118 20.0829 21.2013 -17.1516 -4.14152 -12.2545 -5502 6 50.9933 10.2578 30.842 -13.0607 -20.693 1.71035 -5503 4 51.4592 11.0512 30.6346 13.219 20.5706 -0.472754 -5504 4 50.4501 10.1493 30.0523 -4.00654 -4.85851 -2.78428 -5505 6 16.2749 2.41767 41.3132 30.43 46.2693 -10.4997 -5506 4 15.891 1.63581 41.6436 -18.412 -43.9133 0.0464609 -5507 4 16.2795 2.47169 40.3396 -9.09423 -14.5759 6.47164 -5508 6 16.5834 4.98938 41.8776 -7.21709 18.0228 -35.1788 -5509 4 16.7462 5.00964 0.881122 10.2158 10.5242 44.5139 -5510 4 16.3516 4.0781 41.7536 -3.71457 -12.9135 -9.58407 -5511 6 38.2173 37.6461 20.9885 34.7311 9.53448 3.02785 -5512 4 38.1039 38.1836 20.1861 -3.89758 -6.06348 6.62032 -5513 4 39.1638 37.7895 21.271 -30.6928 -4.57838 -6.40603 -5514 6 27.3006 1.89931 15.7822 -29.9599 0.296682 7.03709 -5515 4 27.5073 1.31215 15.0574 1.93116 -3.76907 -9.96281 -5516 4 26.3073 1.90747 15.8082 23.9237 -0.0762349 1.33551 -5517 6 29.0265 12.4386 37.8107 0.525722 -10.271 3.33822 -5518 4 29.5022 13.2884 37.7591 0.646351 -6.15481 8.15455 -5519 4 29.2991 11.9227 38.6151 -0.523918 21.8031 -11.8471 -5520 6 46.0742 20.1649 18.9021 10.3528 7.89056 -10.7305 -5521 4 45.1842 20.5502 18.8696 3.90233 0.901411 -3.14496 -5522 4 46.6469 20.7119 18.3183 -8.66547 -7.99067 8.59505 -5523 6 2.04022 38.6829 18.5084 -2.98341 9.82285 -40.3455 -5524 4 2.90324 38.7749 18.9245 -0.612017 -3.29975 20.9344 -5525 4 1.3228 38.3823 19.0758 6.43327 -3.78011 20.6074 -5526 6 44.0503 24.9822 25.9794 4.67294 -4.59524 3.88497 -5527 4 44.3373 24.0607 26.0767 4.76241 4.2408 6.41339 -5528 4 43.5759 24.9717 25.1449 -4.92835 3.44315 -2.97359 -5529 6 5.98031 26.6293 4.53551 9.30387 5.64625 14.1271 -5530 4 6.57491 27.1353 5.14729 -11.3776 -17.0368 -12.135 -5531 4 6.21313 25.677 4.5841 -4.82905 19.4284 -2.02229 -5532 6 0.0924267 23.2133 10.9333 1.42961 0.53672 3.80218 -5533 4 0.717354 23.7388 10.4004 2.9288 -9.65077 10.1872 -5534 4 0.580921 22.6863 11.5989 -3.01683 9.30052 -9.37626 -5535 6 39.1222 20.6154 12.8741 28.3348 2.95161 0.461931 -5536 4 40.0468 20.8249 13.1753 -23.4009 -9.33487 -2.82098 -5537 4 38.9932 21.1408 12.0685 -0.0080483 -0.226832 2.68059 -5538 6 39.959 39.9495 18.871 8.01281 1.93571 -21.8826 -5539 4 39.6441 40.4313 18.0693 6.09748 -11.7745 18.4856 -5540 4 39.3412 40.1359 19.5607 -16.2687 5.42221 11.8382 -5541 6 49.288 23.0046 30.5128 21.2206 -9.75551 18.5897 -5542 4 49.5389 23.7528 30.0013 -1.98497 24.1116 -29.9204 -5543 4 49.9896 23.0569 31.1809 -5.40626 -11.587 6.30696 -5544 6 10.3545 2.34292 9.14765 -20.562 40.259 12.8074 -5545 4 10.1012 1.5797 8.68555 -3.02669 -36.876 -18.9145 -5546 4 9.58966 2.94108 8.9894 20.4134 -0.423974 9.05106 -5547 6 9.6115 40.9317 19.7379 12.0905 -27.6191 -4.08509 -5548 4 9.69139 40.7751 18.7589 3.32448 -0.840478 24.839 -5549 4 9.96472 40.0953 20.2033 -15.7711 32.9781 -27.126 -5550 6 29.2535 5.10379 17.4957 6.62295 15.7752 6.05206 -5551 4 28.9547 4.7998 16.6324 -1.76299 0.290572 -5.22762 -5552 4 29.5626 6.02275 17.3534 -3.29284 -14.1281 1.20249 -5553 6 27.0956 15.411 3.22262 8.43004 -47.4217 3.28637 -5554 4 27.2677 16.3043 3.38591 1.16524 52.1129 6.18754 -5555 4 27.741 14.9724 3.82188 -13.792 3.46242 -10.72 -5556 6 32.8341 39.3821 25.1177 -1.66938 -44.1854 21.376 -5557 4 32.6253 40.2767 24.9331 -7.27917 31.8978 1.68524 -5558 4 32.4689 39.1753 26.0219 6.68592 11.3878 -26.9617 -5559 6 34.9613 7.8883 31.2358 4.6626 36.0744 6.61898 -5560 4 34.1778 8.39814 31.5057 7.62156 3.23778 -2.6687 -5561 4 34.6431 7.01199 31.2355 -6.57887 -35.8668 -2.78431 -5562 6 6.13276 36.7597 26.1434 10.8988 16.6869 20.3463 -5563 4 6.63888 37.4372 26.6797 -12.2659 -21.448 -21.9021 -5564 4 6.61066 36.5785 25.3331 5.0666 0.722926 -2.43587 -5565 6 6.00975 25.8323 24.1014 -4.47961 0.932019 -2.36624 -5566 4 6.35352 25.3647 24.9068 -18.3984 14.8695 -13.0656 -5567 4 5.16189 26.3111 24.2876 18.65 -15.8322 7.58859 -5568 6 45.6302 24.3945 2.56021 19.8484 -5.54431 -0.0961329 -5569 4 46.4674 24.0527 2.19931 -2.34639 0.0383291 -2.49188 -5570 4 45.6784 24.1611 3.48508 -4.52597 -1.56916 11.2469 -5571 6 15.5147 11.7041 32.683 14.9804 20.126 19.7749 -5572 4 15.7333 12.537 33.1619 -4.31998 -20.325 -9.45866 -5573 4 14.9494 12.0119 31.9786 -9.0483 1.88099 -11.1618 -5574 6 46.4109 17.7015 37.4781 -27.0258 -32.7931 -28.9932 -5575 4 46.5427 17.8951 38.3867 3.19976 6.65122 29.0636 -5576 4 45.8763 16.8534 37.4192 15.4316 28.8096 -0.764517 -5577 6 39.7197 20.9143 18.534 -24.0731 20.2285 32.8184 -5578 4 40.3775 20.5463 17.9571 20.7324 -0.0260386 -6.5243 -5579 4 40.0771 21.5962 19.1648 -0.0511872 -19.8333 -22.8182 -5580 6 23.8035 28.041 36.6748 9.0016 14.1447 -6.24075 -5581 4 23.3139 27.2938 37.064 2.44252 16.2828 7.25552 -5582 4 23.789 28.845 37.2599 -7.88527 -27.7019 -2.97202 -5583 6 23.2344 0.634844 30.8976 -0.384503 -14.0448 -5.97485 -5584 4 23.3889 41.8653 31.5825 6.30765 2.44689 -9.38002 -5585 4 23.8441 0.49945 30.133 -8.72578 -2.57312 14.648 -5586 6 37.1436 6.89172 28.2858 -3.37167 6.44507 30.6351 -5587 4 36.8056 6.23733 28.9583 11.2574 17.9183 -21.3683 -5588 4 37.4325 7.68669 28.8192 -8.94015 -21.4647 -17.7418 -5589 6 3.23535 6.60909 12.3935 -1.87368 1.73448 8.36027 -5590 4 3.03832 6.9284 11.4867 8.20532 -9.84476 7.71099 -5591 4 3.52123 5.67427 12.3822 -6.77188 11.8795 -6.70084 -5592 6 12.6173 19.1518 31.1213 -5.69854 -18.2223 8.29425 -5593 4 12.5903 18.2248 31.5183 -0.203161 27.8336 -18.7857 -5594 4 12.2771 19.1425 30.2049 2.23067 -5.60852 14.6148 -5595 6 15.1884 38.3149 41.5578 -3.57026 -0.303434 0.776802 -5596 4 15.4085 38.7623 40.7331 -1.55695 3.41656 0.7558 -5597 4 16.0064 37.8692 41.7958 4.70682 -3.66196 2.37744 -5598 6 49.6308 33.3399 19.6427 -23.754 -26.2674 -4.71234 -5599 4 48.6425 33.4171 19.8493 35.7001 -9.4047 -10.4581 -5600 4 49.8006 32.395 19.3286 -9.63678 35.3831 11.1391 -5601 6 6.36026 2.78098 29.8944 3.74937 13.951 -9.77631 -5602 4 6.39713 3.75696 29.8119 -0.635871 -14.0149 2.80012 -5603 4 6.09114 2.63212 30.8044 -1.55083 -4.44243 9.60337 -5604 6 13.1715 31.7798 30.2783 -11.6407 3.9064 -21.9894 -5605 4 12.793 31.9725 29.3819 8.72012 -0.590438 18.6573 -5606 4 12.9685 30.8401 30.4245 2.82441 5.28785 4.26217 -5607 6 32.3245 32.246 24.8932 -0.334642 -17.4514 3.51608 -5608 4 32.5833 31.3985 24.4266 1.55373 29.7789 3.70352 -5609 4 32.7413 33.0821 24.5914 4.2936 -14.9539 -9.40787 -5610 6 41.9919 14.5701 37.4124 -31.8928 -38.2057 -11.1184 -5611 4 41.1925 13.9916 37.278 11.7187 28.3557 2.93562 -5612 4 42.6351 13.8531 37.4242 20.2579 6.94588 1.70752 -5613 6 11.8923 7.24234 27.6655 -13.1666 -25.4093 6.94854 -5614 4 11.7936 6.42612 28.2118 8.91213 18.8361 -2.40188 -5615 4 11.255 7.06027 26.9538 4.64331 9.73453 -0.841263 -5616 6 14.1973 37.538 6.88791 4.07782 -38.2298 -28.3639 -5617 4 14.4575 38.4426 6.80778 6.05638 30.4198 1.96843 -5618 4 14.5936 37.1092 6.07523 -12.6749 10.0326 27.426 -5619 6 14.2479 30.6948 36.0545 7.37408 36.4971 9.0133 -5620 4 14.3981 30.7629 35.1101 2.39159 -10.6067 -11.9788 -5621 4 14.1779 29.7876 36.2972 -1.09854 -35.7585 -0.14866 -5622 6 16.4334 33.6494 5.49228 -9.96541 -28.1856 -5.39099 -5623 4 16.7983 34.5397 5.45321 9.37649 -3.55324 -12.1003 -5624 4 16.7788 32.9912 4.81355 -0.655183 31.9156 12.6517 -5625 6 23.0317 17.1547 7.8473 13.6053 -0.132883 9.10362 -5626 4 22.1841 17.362 7.40272 9.91908 10.567 10.3381 -5627 4 23.4804 17.9296 8.30446 -24.7767 -19.3244 -18.4116 -5628 6 51.7425 20.8913 27.7088 32.6403 -5.30395 6.54704 -5629 4 51.4526 20.615 28.6066 9.31531 5.01366 -13.1678 -5630 4 52.7523 20.9899 27.7096 -40.0215 -4.95426 2.55021 -5631 6 2.19474 27.6072 28.8013 -23.9703 3.8216 12.4498 -5632 4 2.89306 28.2617 29.0045 8.22653 -14.998 -10.5048 -5633 4 2.42593 26.8662 28.2089 10.4722 10.3682 5.46115 -5634 6 17.2069 14.3387 7.70681 0.210359 -30.5014 22.2216 -5635 4 16.8342 14.1932 8.62484 13.2745 1.87397 -27.442 -5636 4 17.791 13.5503 7.49447 -17.8498 26.4292 5.4189 -5637 6 12.462 8.93964 14.7065 0.798528 8.71873 -6.67623 -5638 4 12.2438 7.98523 14.5568 11.6803 11.8078 17.0064 -5639 4 13.0577 9.12873 15.4809 -12.5262 -17.6243 -12.8578 -5640 6 42.4139 38.0579 9.76413 -20.5008 17.2265 16.0611 -5641 4 43.2035 37.8944 10.2554 20.3834 -6.45835 6.72371 -5642 4 41.8905 38.6035 10.3913 3.31942 -7.4886 -15.3201 -5643 6 51.8227 30.3513 28.272 -27.6927 -20.9124 31.2363 -5644 4 51.4089 31.1514 27.9711 0.163888 16.7369 -10.597 -5645 4 52.6546 30.2313 27.8441 24.1641 3.9866 -16.3823 -5646 6 0.181148 18.531 4.58976 -5.95747 22.8787 14.3331 -5647 4 0.30783 18.164 3.72574 1.94264 -10.8238 -19.8991 -5648 4 0.385506 17.861 5.23812 2.38695 -15.8688 4.81738 -5649 6 34.1492 0.61754 2.99129 -49.6439 4.42439 -16.0687 -5650 4 33.2398 0.938351 2.63038 43.5613 -10.8791 15.5023 -5651 4 34.8325 1.13587 2.566 3.67212 10.3309 -6.27046 -5652 6 49.171 17.2374 23.1529 12.6877 -22.0026 -17.2704 -5653 4 50.1002 17.5391 23.0823 -12.4494 -3.65532 2.68691 -5654 4 49.1558 16.3609 22.6932 2.16788 22.8154 9.36775 -5655 6 23.1488 6.5083 23.6124 -20.5997 37.6057 -45.0229 -5656 4 23.0491 7.12001 22.8007 18.1878 -21.95 27.0503 -5657 4 22.2316 6.45775 23.8939 -1.28085 -6.53623 13.7239 -5658 6 11.0806 24.0842 29.2705 -8.73998 -10.3514 -18.9502 -5659 4 11.2441 23.4599 28.5168 0.0150655 10.4905 16.9308 -5660 4 11.7296 23.9083 29.9561 7.87164 -2.5542 2.12029 -5661 6 36.5429 4.08242 21.672 0.786556 -8.94696 -15.3954 -5662 4 36.4501 4.49554 22.5359 -3.35109 8.47972 1.84417 -5663 4 36.356 4.76727 20.9996 1.47044 -5.20042 11.1851 -5664 6 31.3053 25.6355 24.591 -3.66138 3.71718 3.54675 -5665 4 31.1335 26.2845 25.3159 5.93159 -20.4343 -13.8963 -5666 4 32.0778 25.0682 24.8002 -7.66178 11.3294 7.22687 -5667 6 42.6065 23.0403 14.7613 -16.8309 4.03618 -45.3098 -5668 4 42.9655 23.4598 13.9577 -8.276 -4.36486 -1.00498 -5669 4 43.204 23.3098 15.4118 29.6291 10.3091 46.448 -5670 6 14.3159 11.6727 8.8813 -14.5655 -17.9373 -12.2817 -5671 4 13.3434 11.4421 8.85146 29.9821 6.96631 -2.22077 -5672 4 14.7728 10.9717 8.34565 -11.3371 15.3318 14.175 -5673 6 21.498 2.14139 3.39648 14.7702 -17.8734 -6.06988 -5674 4 22.405 2.21099 3.73647 -11.0312 3.8274 -0.37696 -5675 4 21.4855 1.24815 2.9799 -4.51333 14.3419 9.54204 -5676 6 22.4606 27.6741 39.0725 -9.38699 -8.57051 -12.0691 -5677 4 22.9487 28.2157 39.6788 9.87489 12.9386 7.45564 -5678 4 22.251 26.9021 39.5804 -3.7481 -10.0177 3.53978 -5679 6 37.2705 33.4961 30.0614 -4.9469 -17.1986 11.1636 -5680 4 36.5019 32.9393 30.3108 14.0133 8.69925 -1.52787 -5681 4 38.0636 33.0902 30.4641 -13.5236 2.40347 -6.71067 -5682 6 41.8394 20.8621 40.0097 -20.8091 -17.9415 -11.9484 -5683 4 40.8821 20.7467 40.2088 17.4772 5.45688 -4.89215 -5684 4 42.2425 21.2111 40.795 8.11745 4.61319 15.3924 -5685 6 10.0509 31.1054 22.2556 20.3961 -18.8014 17.2446 -5686 4 9.98499 30.8639 23.2007 -4.95143 3.66172 -13.3958 -5687 4 9.23459 31.4918 21.9926 -24.2979 8.76968 -3.95477 -5688 6 24.2243 35.3747 6.62617 -9.42531 -3.96828 -6.7527 -5689 4 23.2865 35.2144 6.56466 -9.91939 -6.68958 -24.4488 -5690 4 24.2401 35.6133 7.54088 22.4532 10.3619 17.5563 -5691 6 54.2249 13.3694 18.759 -24.737 -0.349871 -1.41807 -5692 4 53.5933 13.3703 18.006 15.3609 1.78219 9.05355 -5693 4 53.6566 13.499 19.5435 10.7967 -0.400371 -8.89572 -5694 6 12.4855 25.1013 17.4456 -6.57337 13.5018 5.68311 -5695 4 11.9686 25.7405 17.9864 9.67417 -13.0798 -6.23069 -5696 4 12.9177 24.4729 18.0482 -8.67745 6.31928 -4.55572 -5697 6 22.3956 33.969 18.8874 -5.8063 -1.6479 -7.81353 -5698 4 22.8035 34.4497 18.1359 -8.0332 -6.19684 5.18696 -5699 4 21.6693 33.408 18.5182 22.6878 13.045 2.20471 -5700 6 24.4435 12.9292 5.84415 8.74588 -19.8564 16.0901 -5701 4 24.6262 13.8512 5.99703 -0.326218 20.1414 -4.57271 -5702 4 23.8078 12.8376 5.13214 -2.90401 5.95194 -4.82348 -5703 6 13.3959 11.2335 28.6038 -6.74888 -5.61354 -5.54718 -5704 4 13.7674 10.4842 28.0847 -9.93712 8.82772 12.9583 -5705 4 12.6218 10.8864 29.0903 8.08376 -4.51111 -11.0518 -5706 6 20.9645 34.7015 21.139 -6.51648 1.45471 -0.425004 -5707 4 21.4543 35.0255 21.9119 2.52902 -3.67403 -7.94594 -5708 4 21.5071 34.7067 20.3201 -1.1119 -0.149268 16.7291 -5709 6 37.136 34.5081 26.161 6.62209 -8.97684 -22.2932 -5710 4 37.2438 34.333 25.2112 -5.73965 -6.14541 10.65 -5711 4 37.5173 35.375 26.2088 1.33918 12.2816 12.8311 -5712 6 49.3593 27.1123 23.4681 27.9614 -13.0657 2.71617 -5713 4 48.46 27.3383 23.3348 -38.0547 10.3981 -3.53627 -5714 4 49.5827 26.632 22.6632 1.14175 -6.15755 -6.01297 -5715 6 2.6463 41.7198 27.6524 7.3894 17.9878 -25.5957 -5716 4 2.49639 41.7504 26.6775 -8.79282 -10.4379 14.5056 -5717 4 3.38399 0.440368 27.7439 -10.0848 -7.80081 10.7778 -5718 6 28.2486 5.66281 0.851705 -28.2484 -11.3463 5.20358 -5719 4 29.1342 5.88017 0.643235 30.8656 11.4658 -5.99415 -5720 4 28.269 4.69693 0.891643 -4.88577 1.64465 1.4719 -5721 6 46.3319 19.9354 30.6504 10.2867 19.401 8.99033 -5722 4 46.9123 19.9353 29.8821 -3.84989 -4.07474 -6.11394 -5723 4 46.5975 20.7732 31.0971 -12.3274 -18.5124 -2.17733 -5724 6 3.63748 25.7835 21.5531 -13.3498 -8.40935 -29.3244 -5725 4 3.82697 24.8656 21.7578 10.5845 0.467441 11.0774 -5726 4 3.24958 25.6945 20.6565 5.98204 10.7305 11.6574 -5727 6 2.75525 19.0991 29.6309 -15.3907 3.66354 13.2976 -5728 4 3.52302 18.6052 29.9384 7.69741 -2.11378 -3.28897 -5729 4 2.98375 19.5594 28.8227 11.6258 3.58084 -5.99316 -5730 6 11.8998 35.7779 24.2574 -1.81403 7.91701 -5.71356 -5731 4 12.4147 34.9912 24.3376 10.7342 -20.9531 7.85436 -5732 4 12.5443 36.3811 23.8879 2.19538 16 -3.69366 -5733 6 52.3427 30.4062 14.294 22.5839 4.39347 1.37497 -5734 4 52.8745 31.0934 14.7488 -8.66891 -1.23278 -4.46489 -5735 4 51.4935 30.7804 14.0876 -13.5204 11.8147 1.32314 -5736 6 0.0822874 24.3672 32.1291 -8.34182 -9.5272 -6.40877 -5737 4 0.828194 24.8082 31.7001 -5.59692 5.0286 6.41936 -5738 4 -0.0482457 24.7479 33.0025 4.35174 8.79498 5.58774 -5739 6 31.4966 23.7292 38.8152 19.1094 38.0757 -4.99319 -5740 4 31.5999 23.5133 39.7508 -8.21927 -12.2318 -1.63758 -5741 4 30.9751 23.0699 38.3783 -13.0662 -23.7861 4.62116 -5742 6 52.1169 21.6052 3.50792 14.3711 -14.904 -13.5765 -5743 4 52.8807 21.6364 2.89306 -16.3122 -4.91238 6.22228 -5744 4 52.1257 22.4771 3.8768 -2.65107 18.1744 9.91254 -5745 6 31.7478 33.9414 11.5999 6.40399 -14.705 -7.35618 -5746 4 31.326 34.316 12.3745 -3.98661 3.76902 9.36008 -5747 4 32.1024 33.0666 11.8569 -5.74966 15.1553 -0.43871 -5748 6 7.04869 17.6722 16.6738 15.5169 9.78585 -46.6303 -5749 4 6.86408 17.1452 17.4554 -1.12856 -17.4359 1.80272 -5750 4 7.18951 17.0724 15.8577 -9.09698 16.5018 49.1326 -5751 6 51.856 41.8666 22.1892 3.84753 25.5265 -21.3427 -5752 4 52.3772 41.4924 22.8897 9.65371 -13.9556 16.5062 -5753 4 51.0512 41.3628 22.1522 -12.8828 -14.9996 6.2925 -5754 6 50.8708 9.92691 25.9357 -19.3562 -16.2947 3.52683 -5755 4 50.5833 10.1225 25.0455 -2.85771 2.39787 -5.58996 -5756 4 51.6551 10.4289 26.0882 17.2727 16.0662 4.10656 -5757 6 8.99927 39.8664 13.8488 -8.14038 -13.6283 -23.156 -5758 4 9.59929 39.3497 14.3885 6.06913 -3.61279 3.55219 -5759 4 8.79522 39.3067 13.0547 7.60199 16.2117 22.1745 -5760 6 40.7023 25.5302 0.148896 6.79038 -13.4508 8.01702 -5761 4 40.3789 25.4701 1.07476 14.4856 1.96217 -11.1718 -5762 4 41.6802 25.6099 0.149801 -17.1473 -2.90233 2.89792 -5763 6 46.6909 7.84537 22.8702 9.17253 9.27189 2.7581 -5764 4 46.223 7.4121 23.6122 6.69651 11.5962 -1.82232 -5765 4 47.0858 8.70418 23.1544 -10.5797 -14.2101 5.83025 -5766 6 21.013 12.9106 9.96683 -11.4772 33.9385 12.3935 -5767 4 21.4714 12.292 10.5062 17.1864 -22.5118 18.142 -5768 4 21.2487 12.7153 9.07972 8.38308 -10.8862 -30.7653 -5769 6 24.8549 0.515446 28.6008 5.68052 19.4063 -7.13145 -5770 4 24.6132 0.0822417 27.7678 -2.25298 -0.561161 -0.933523 -5771 4 24.9931 1.46483 28.3802 -3.69568 -16.6941 4.65055 -5772 6 9.93738 22.6806 8.27387 -17.0851 30.8612 6.83622 -5773 4 10.4469 21.9921 7.84938 5.97494 0.327216 -18.4105 -5774 4 9.65147 23.3826 7.61609 12.4321 -25.0338 8.46255 -5775 6 33.2759 9.25001 23.8237 4.47891 -44.2955 15.8461 -5776 4 33.2652 10.105 23.448 0.909732 36.8069 -18.0196 -5777 4 34.1325 8.84557 23.5962 -5.93924 6.51534 1.57833 -5778 6 47.795 20.3665 34.2866 5.36639 25.6433 -13.2606 -5779 4 47.2589 21.0165 33.753 7.81309 -27.8153 16.882 -5780 4 47.2984 19.5618 34.502 -10.2742 8.68957 -7.27829 -5781 6 7.49437 13.498 41.0843 -1.51987 -1.91843 -16.5508 -5782 4 7.4491 13.1887 40.147 4.71488 4.53153 18.247 -5783 4 8.31974 13.1617 41.4819 -4.68073 -1.19795 -7.02436 -5784 6 9.95832 23.5973 1.60681 5.21402 2.49741 5.68021 -5785 4 10.4402 24.1882 0.998507 -5.12041 -6.82862 1.89989 -5786 4 9.65493 22.8254 1.1174 1.14228 -2.219 -8.51506 -5787 6 27.3184 14.1623 11.3341 -13.0256 18.3326 19.191 -5788 4 27.0532 14.8043 10.6617 -0.288735 -3.87647 -1.15481 -5789 4 27.1082 14.6278 12.1878 10.7132 -11.7932 -20.1286 -5790 6 25.8363 31.783 17.8928 12.257 -31.4953 -8.75538 -5791 4 26.5912 31.2312 17.6268 -16.3657 -3.28218 2.7807 -5792 4 26.257 32.5845 18.0942 8.13437 40.9862 10.9181 -5793 6 28.5106 34.3419 0.227626 33.3873 17.7784 12.057 -5794 4 28.9852 33.8482 0.904042 3.3493 0.859906 2.37016 -5795 4 27.7339 33.8559 0.0766936 -35.6263 -19.3635 -8.63216 -5796 6 39.4752 27.6784 22.7097 42.3367 15.2059 -23.9811 -5797 4 38.5679 27.9307 22.8105 -22.3645 11.7157 0.32019 -5798 4 39.9498 28.4084 22.1978 -16.9125 -22.6846 16.1018 -5799 6 19.4034 35.5119 37.6428 33.5095 -11.1022 16.798 -5800 4 18.7953 34.9333 37.2031 -16.031 -7.23993 -11.3762 -5801 4 20.0399 34.8524 38.0282 -15.2165 20.9239 -9.15559 -5802 6 40.2577 30.223 10.7322 40.2352 -13.6393 -47.8395 -5803 4 40.0003 30.153 11.624 -20.3139 3.96126 40.955 -5804 4 39.7054 30.7997 10.2038 -14.6911 14.5022 3.62333 -5805 6 44.8252 28.467 36.0943 -27.9317 -39.6182 20.2271 -5806 4 44.1 27.9067 36.617 42.0807 42.9759 -26.5645 -5807 4 44.8315 29.4044 36.3472 -5.71594 -8.07431 0.279077 -5808 6 17.9328 13.9421 34.2756 -23.0398 37.6904 -16.8553 -5809 4 17.2847 14.658 34.0723 21.6532 -14.16 -3.36915 -5810 4 17.4769 13.4978 34.9742 -2.33669 -21.4636 20.9706 -5811 6 22.7722 11.8049 25.9053 18.1639 13.4769 -8.32772 -5812 4 22.5143 10.954 26.1764 -32.0329 -27.8082 11.3637 -5813 4 23.7113 11.6387 25.939 19.9678 17.8754 -6.33473 -5814 6 27.9844 31.9785 40.3628 4.4159 -7.73511 16.6787 -5815 4 28.3104 32.752 39.9101 2.36742 5.81951 -9.83175 -5816 4 27.6866 31.3262 39.7216 -3.89657 2.92736 -3.90823 -5817 6 29.7056 5.13899 29.6966 36.1554 -28.1732 -9.81385 -5818 4 29.3242 5.52633 30.4675 -11.5775 13.5815 21.5043 -5819 4 30.5867 4.74321 29.9895 -34.1051 15.4003 -14.984 -5820 6 3.10893 21.4798 2.76501 -7.99866 -19.5262 -7.43282 -5821 4 2.82658 22.3873 2.73831 -4.86294 14.1814 1.21532 -5822 4 2.47005 21.0041 2.20282 6.80672 4.92349 5.4824 -5823 6 13.6497 30.6638 39.7451 -45.1888 -1.5 -27.4221 -5824 4 14.5316 30.8766 39.996 26.4643 7.88404 -4.33129 -5825 4 13.4124 30.9677 38.8135 13.6057 -6.06521 34.9266 -5826 6 39.188 23.0895 28.2562 15.2318 22.185 -40.3341 -5827 4 39.2961 23.1894 27.2636 -4.5014 -1.37473 28.8386 -5828 4 38.6302 22.3345 28.3879 -14.2617 -17.3372 5.24228 -5829 6 16.9988 23.7489 0.769214 20.7079 -15.4466 5.05665 -5830 4 16.2107 23.4786 1.24898 -3.68938 2.33828 -2.20359 -5831 4 17.6949 23.1909 1.19915 -10.9726 17.7258 -9.6056 -5832 6 0.328251 33.6592 13.0294 5.05621 13.0457 -18.8804 -5833 4 55.0348 32.9975 13.677 0.78154 12.2617 9.8199 -5834 4 0.388277 34.5816 13.3997 -6.36603 -34.6234 2.68168 -5835 6 49.1005 40.6595 16.9496 -9.76098 4.73909 -13.8177 -5836 4 49.2151 40.9775 16.0207 -4.23419 -6.48803 14.4163 -5837 4 48.1506 40.7848 17.1408 8.79948 2.71791 -6.65809 -5838 6 52.1337 39.9918 15.1756 26.7545 10.0433 -2.50902 -5839 4 51.9708 40.0067 16.1202 -6.38877 -4.81519 5.40892 -5840 4 51.3465 39.7494 14.7166 -22.4824 -4.17003 -7.64187 -5841 6 29.052 37.1033 37.836 19.097 -0.968932 -4.5801 -5842 4 29.682 36.5364 38.3049 -8.87198 1.40853 -5.4338 -5843 4 28.3717 37.2982 38.474 -12.8547 4.6316 9.68073 -5844 6 4.87585 1.47991 27.5772 1.0193 4.57332 -1.4391 -5845 4 5.21258 1.06654 26.7686 1.92757 2.57678 7.5628 -5846 4 5.62617 1.67061 28.1638 -3.61661 -2.55781 -2.1886 -5847 6 43.5959 24.3463 30.211 -19.7182 -5.92862 14.3815 -5848 4 44.3514 23.9347 29.8066 13.2495 -10.0411 -7.84874 -5849 4 42.954 23.6392 30.3929 6.93549 5.0637 -4.64144 -5850 6 33.7524 3.52358 22.9355 4.65558 -3.45748 -24.1115 -5851 4 34.2253 2.7722 22.5212 -9.10678 14.6802 11.3369 -5852 4 33.6063 4.18077 22.2154 2.29559 -11.8514 17.7295 -5853 6 19.8909 13.4517 25.3922 5.25873 -5.74859 -7.9771 -5854 4 20.5096 14.0736 25.7535 5.66529 16.002 2.33546 -5855 4 19.9521 12.7313 26.0185 -3.34295 -15.2779 0.0169051 -5856 6 47.3737 23.1767 39.6212 -5.95621 11.0118 4.46955 -5857 4 47.7191 22.5265 39.0041 4.75348 -8.18234 -7.77672 -5858 4 47.7813 24.0201 39.3891 1.84918 -0.94156 0.213564 -5859 6 20.1771 18.6734 32.3906 -2.68035 -24.6067 18.319 -5860 4 19.7167 19.3347 31.8914 0.274713 15.8779 -14.5216 -5861 4 21.1289 18.7867 32.3383 1.39014 4.37005 -4.23212 -5862 6 0.462706 5.80795 25.6713 -7.84599 -7.21428 -45.242 -5863 4 0.323825 6.56383 25.0471 7.25451 -11.4554 20.6165 -5864 4 0.632949 6.14438 26.5418 1.37183 20.4375 17.7538 -5865 6 6.87393 19.55 31.9207 -32.7339 30.668 -22.5905 -5866 4 6.24577 19.9891 32.5577 15.6688 -11.8235 -17.9631 -5867 4 6.64633 19.9665 31.0139 13.7505 -20.7976 33.8805 -5868 6 6.72837 20.2799 38.5105 -3.64262 3.78431 -13.5507 -5869 4 5.92588 20.8248 38.5086 9.85336 -2.70512 -1.72466 -5870 4 6.83039 19.9897 39.4188 -3.49896 1.12624 1.5432 -5871 6 22.0356 25.927 12.2605 -11.8373 -4.76705 -8.63625 -5872 4 21.2326 25.5939 11.7351 40.6868 7.42656 16.975 -5873 4 22.8707 25.497 11.9923 -13.8486 -7.11072 -10.1952 -5874 6 39.3057 7.93299 2.64755 -0.118713 9.42534 0.0803503 -5875 4 39.6638 8.10481 3.53463 2.86319 -1.68774 -0.268253 -5876 4 39.5974 7.06378 2.35963 5.09861 -8.7519 2.38745 -5877 6 29.9647 22.0457 34.4057 2.14844 7.25734 -28.1517 -5878 4 30.9338 21.915 34.3365 -18.2911 3.03872 -0.832433 -5879 4 29.6238 22.2503 33.4865 4.56359 -4.84177 28.516 -5880 6 37.5951 16.2788 0.369586 8.64826 -19.3515 -0.400608 -5881 4 37.1939 15.3927 0.526929 9.97291 14.3398 -5.3998 -5882 4 38.4404 16.082 41.8172 -10.5319 -0.823814 4.55326 -5883 6 11.7218 13.8845 21.8896 14.7882 -39.2126 -46.5495 -5884 4 11.9305 13.3995 21.0267 -7.58848 27.5443 23.8472 -5885 4 11.7147 13.1405 22.4934 -2.11531 -1.20748 18.2217 -5886 6 33.352 10.9238 27.6262 4.19409 14.5082 -21.7958 -5887 4 32.741 11.5866 27.2704 3.79692 -6.80494 8.02232 -5888 4 34.0591 10.8732 26.9373 -11.2958 -2.76298 18.1193 -5889 6 30.9422 36.5217 10.1011 0.546516 -38.0529 -7.53065 -5890 4 31.037 36.4313 9.10316 -3.7795 -1.86296 33.6151 -5891 4 30.9555 35.5897 10.5034 1.2522 32.9448 -19.5962 -5892 6 45.5828 6.56917 25.2425 13.4794 -38.3135 -0.0969536 -5893 4 44.6735 6.51564 25.4913 -20.1668 12.9455 3.79285 -5894 4 45.8221 5.605 25.2656 2.31227 28.4662 -4.04899 -5895 6 9.53612 30.0233 12.041 13.8898 -20.9008 -19.4413 -5896 4 9.92894 30.5763 11.3437 -1.97905 0.820167 2.98642 -5897 4 9.13364 30.6129 12.6538 -15.721 17.9312 16.9413 -5898 6 53.0747 24.9738 1.38132 -1.86355 2.7084 19.7503 -5899 4 52.7154 24.2509 0.898374 -13.0694 -24.4059 -9.99565 -5900 4 53.2522 25.5795 0.686793 9.94881 23.634 -11.856 -5901 6 26.1984 24.7352 0.509304 -7.53082 -0.727442 -26.3589 -5902 4 25.609 24.783 41.6367 17.1237 -12.5609 6.929 -5903 4 25.7967 25.3842 1.06587 -1.32139 13.3231 25.2347 -5904 6 23.0109 2.41889 11.5345 -1.81733 -0.917938 -19.7561 -5905 4 22.156 2.16845 11.9124 1.98231 0.963836 1.10425 -5906 4 22.831 2.471 10.5696 1.38956 0.195961 11.1121 -5907 6 29.9165 12.8947 31.0013 41.0722 8.15666 -12.068 -5908 4 30.8272 12.8901 31.3843 -23.6061 -3.22469 3.62361 -5909 4 30.1671 13.0589 30.0659 -21.5099 -4.3955 11.2257 -5910 6 24.0423 16.1922 40.3682 -11.7161 -52.7791 -12.7633 -5911 4 23.7963 16.7427 41.0863 -4.03022 37.1909 22.8519 -5912 4 24.4513 16.6836 39.6566 3.29428 17.0417 2.56802 -5913 6 21.8759 29.9137 12.7377 16.7673 9.38207 5.68416 -5914 4 21.0615 29.603 12.3447 -12.732 2.54077 -5.12984 -5915 4 21.8572 30.8889 12.7388 -3.49843 -10.2696 0.0943897 -5916 6 45.2049 12.2865 6.6319 2.92472 30.2037 5.62675 -5917 4 45.4908 11.5347 6.14771 0.0808414 -27.1796 -10.0093 -5918 4 45.9331 12.9133 6.49804 -8.49251 3.31449 4.74769 -5919 6 7.58748 25.3948 38.035 37.4402 -5.69153 16.1754 -5920 4 8.20159 25.1941 37.2709 -20.479 6.14302 24.9331 -5921 4 8.13335 25.2556 38.8857 -20.6102 5.92378 -35.7711 -5922 6 46.1732 7.83303 16.6988 4.4841 14.5494 -17.535 -5923 4 46.5452 7.84101 15.8027 -9.24205 10.2202 -0.760543 -5924 4 46.6945 7.14485 17.0776 9.771 -19.5689 22.069 -5925 6 54.9675 12.85 7.71106 -14.5426 11.3809 9.40253 -5926 4 54.9732 13.8139 7.75484 8.59467 -0.566973 -8.90089 -5927 4 54.3786 12.658 8.45528 8.25441 -10.7611 -5.52346 -5928 6 26.93 39.6729 37.1759 35.4319 -17.0193 24.0328 -5929 4 27.7049 39.4447 36.6239 -16.3058 8.04164 -6.8945 -5930 4 27.2164 39.2553 38.0316 -23.1866 12.5553 -17.3208 -5931 6 27.0277 8.92497 38.0115 25.8258 -15.1538 -19.4143 -5932 4 26.3205 9.53863 38.1727 -14.2244 17.8778 -0.0983549 -5933 4 27.5327 9.26244 37.2322 -14.307 -2.33761 14.5508 -5934 6 8.04621 7.65921 29.9125 5.96085 -8.8046 12.0925 -5935 4 8.66182 7.92407 30.6202 -6.26406 -0.422529 -8.96361 -5936 4 7.80891 8.46925 29.4702 -0.676119 14.2 -7.80782 -5937 6 27.8751 27.8625 12.1001 -31.3933 22.4686 19.454 -5938 4 27.5095 28.719 12.4446 7.36494 -19.3603 -4.77408 -5939 4 28.6439 28.079 11.5991 25.5597 3.40516 -15.3306 -5940 6 23.5464 30.4867 38.1533 -1.61625 -6.62341 9.61758 -5941 4 24.0833 30.8354 38.8715 -5.37174 -4.61911 9.80189 -5942 4 23.9933 30.8636 37.4157 3.53805 3.96797 -22.0348 -5943 6 48.0805 24.2983 17.323 -13.282 16.609 -1.2587 -5944 4 47.4189 24.8263 17.8481 20.4082 -10.1323 -14.146 -5945 4 48.1392 24.7467 16.448 -1.93384 -6.90404 13.1726 -5946 6 38.5137 5.30503 40.3397 -7.95418 19.3032 15.6478 -5947 4 38.8605 4.51762 39.8919 14.9068 5.60332 0.485922 -5948 4 39.0782 6.12858 40.3573 -2.94219 -25.5867 -8.28862 -5949 6 31.2334 3.92786 33.7298 9.31662 9.08835 -13.8199 -5950 4 31.8178 4.24357 33.0198 -6.00608 1.6224 5.38661 -5951 4 31.5957 3.05883 33.9262 -1.57661 -10.2527 7.73336 -5952 6 41.2417 8.81323 38.1247 -0.484904 -12.0607 11.4744 -5953 4 40.9476 8.42023 38.9721 -0.376638 9.54125 -7.13918 -5954 4 41.2604 9.77162 38.2616 1.58028 -2.03482 4.89657 -5955 6 53.3602 29.1001 24.587 -11.0956 7.72569 2.80506 -5956 4 52.5731 28.5594 24.8544 13.5868 20.3826 -7.54714 -5957 4 53.0545 29.9696 24.221 1.09296 -21.6534 7.27768 -5958 6 54.9204 15.5334 40.7094 -9.73888 -15.8123 9.62316 -5959 4 54.8689 16.4143 40.4003 18.499 35.235 -15.9181 -5960 4 53.9936 15.418 40.9228 -4.36807 -19.1537 6.40504 -5961 6 46.4046 17.0769 31.8825 -4.88415 8.61979 -0.317809 -5962 4 46.5643 17.9902 31.5503 -4.54791 -14.0743 0.407713 -5963 4 45.6863 16.6828 31.3336 12.87 12.2001 8.08584 -5964 6 36.9136 25.0502 23.0508 4.56287 5.14957 -21.3849 -5965 4 37.1181 25.0639 23.9643 8.53293 7.7605 31.6671 -5966 4 36.2092 24.4176 22.9617 -10.0712 -5.98832 -5.36051 -5967 6 11.3786 4.43396 15.9309 9.37238 17.2608 -3.05203 -5968 4 11.3458 3.5794 15.4688 2.43716 9.1998 0.97888 -5969 4 11.7026 5.12247 15.2999 -5.70859 -16.4138 5.77914 -5970 6 12.7896 7.06818 19.4525 -2.66824 36.6483 10.7184 -5971 4 12.9865 6.29411 18.9417 0.495259 -24.323 -4.17525 -5972 4 12.2519 6.828 20.2299 7.04203 -8.59773 -13.3487 -5973 6 12.0617 33.6499 17.5439 8.15138 -13.8576 -23.5514 -5974 4 11.882 34.0654 18.3682 -11.1792 16.7137 24.4072 -5975 4 12.5902 32.8825 17.8108 -1.08307 -0.300652 -3.52071 -5976 6 10.2421 4.75805 2.56564 19.3085 -11.8452 1.86691 -5977 4 9.45693 4.42703 2.99801 -10.4664 -1.42643 2.59081 -5978 4 10.9264 4.04527 2.68225 -6.18235 16.1727 -3.70264 -5979 6 4.57251 36.8735 12.1563 3.74049 -23.6741 -21.1206 -5980 4 4.47996 37.7154 12.5491 -11.9533 34.2042 20.255 -5981 4 5.43811 36.9355 11.7449 0.921031 -10.3689 -0.351167 -5982 6 30.7412 35.3317 25.8213 -33.1423 -23.543 6.44877 -5983 4 31.2776 35.279 26.6136 10.5944 3.70967 -1.00248 -5984 4 29.9668 34.7615 26.0677 13.1622 11.7399 -12.7178 -5985 6 20.1808 7.16217 1.863 30.1084 16.4868 -11.867 -5986 4 20.9002 6.54767 2.16414 -16.0511 17.5979 -8.58506 -5987 4 20.6676 7.94845 1.45686 -14.4541 -29.1822 13.3394 -5988 6 21.7608 6.89709 28.9964 -11.5861 -1.80466 -8.03013 -5989 4 22.036 7.16072 29.8728 6.26891 1.69864 13.9065 -5990 4 22.5393 6.5849 28.5353 8.83449 0.101288 -1.59126 -5991 6 6.87368 37.1369 6.9386 0.0966708 26.3677 27.0276 -5992 4 7.29364 38.0249 6.81033 -7.58004 -19.2864 -7.26696 -5993 4 6.61926 37.1727 7.88431 1.83825 -7.02501 -19.6681 -5994 6 37.1919 18.383 16.2937 29.0289 34.5069 -53.2335 -5995 4 36.6258 18.6038 17.011 -19.1901 14.6481 22.2869 -5996 4 37.3395 19.2625 15.7718 -11.4936 -34.1346 27.3139 -5997 6 52.3871 25.4845 31.3088 43.0013 26.9533 24.6388 -5998 4 52.3889 26.4071 31.692 -12.9868 -26.5619 -15.078 -5999 4 53.3562 25.2868 31.368 -25.5563 -9.18093 -7.26498 -6000 6 3.9438 39.8542 16.3866 5.1752 -27.5036 1.27902 -6001 4 3.12325 39.6837 16.8533 -2.95342 6.97088 0.658243 -6002 4 4.2268 38.9387 16.1321 1.7457 31.291 -0.663648 -6003 6 26.0576 14.6358 18.3044 5.96149 26.4073 -5.45028 -6004 4 27.0205 14.6227 18.4365 -6.17521 2.0803 0.6884 -6005 4 25.8163 15.5963 18.2277 1.60591 -22.5499 1.70317 -6006 6 22.193 39.6312 23.63 -9.05536 -28.9999 9.83005 -6007 4 22.6639 40.3889 23.3083 10.2118 22.7493 1.36107 -6008 4 21.7625 39.8434 24.4837 8.53947 8.47814 -10.8223 -6009 6 5.99591 12.8758 22.3742 5.3436 -0.661706 -0.190442 -6010 4 6.14325 13.1833 21.4713 -0.679137 1.38292 -0.893953 -6011 4 6.87425 12.6139 22.6767 3.78948 -2.07704 1.05968 -6012 6 48.9338 28.1628 34.7078 -35.8712 26.2385 4.15493 -6013 4 48.201 27.5556 34.4701 19.6025 -0.265843 1.21851 -6014 4 49.8217 27.8183 34.7001 12.2446 -20.4038 -3.75147 -6015 6 7.76997 22.4407 33.2353 -5.03116 -11.9457 7.57841 -6016 4 8.01899 22.0009 34.0594 5.33952 7.11928 -2.86974 -6017 4 7.10669 21.8538 32.8613 -1.17853 4.26119 -2.40878 -6018 6 41.0955 39.6222 11.7091 10.6381 -27.5326 3.52715 -6019 4 40.5189 40.2602 11.288 0.0449404 21.7474 -0.525631 -6020 4 41.8612 39.9918 12.1934 -14.1016 15.1893 -9.59654 -6021 6 26.8828 37.915 39.359 -2.28209 0.567193 11.8658 -6022 4 27.0774 38.1179 40.3058 -8.7685 -4.90824 -13.677 -6023 4 25.9807 37.5277 39.3071 12.6176 5.79057 5.20946 -6024 6 16.8333 41.5427 16.7885 -17.5694 -7.84814 -1.75502 -6025 4 17.5277 0.148354 16.3589 5.69783 -2.62712 11.3029 -6026 4 16.9979 41.3393 17.726 8.37907 5.88226 -10.2657 -6027 6 19.018 8.99657 17.6669 -0.857073 -13.2853 32.8939 -6028 4 18.786 9.90902 17.9004 1.19423 -0.949069 -3.8378 -6029 4 19.1413 8.47286 18.5173 -2.13518 15.132 -32.6231 -6030 6 31.1034 24.3848 20.0884 -4.53251 11.7336 -2.81937 -6031 4 30.5766 24.6463 20.8643 6.13742 -4.20791 -6.36966 -6032 4 31.7352 25.0989 19.9557 0.422515 0.146513 0.562515 -6033 6 24.595 6.30881 27.6069 -9.90555 -11.0232 -14.6341 -6034 4 24.6965 6.6392 26.7007 0.89989 8.76246 8.56835 -6035 4 24.5083 5.35606 27.4824 0.344086 -1.65377 9.53776 -6036 6 11.6335 5.32908 8.21523 29.3959 14.5761 -12.3078 -6037 4 10.744 5.12885 8.4339 -32.4949 -9.42488 11.9016 -6038 4 11.5648 6.10082 7.62627 0.276207 -9.77668 5.48929 -6039 6 16.478 34.2375 17.2464 48.0037 -1.61779 7.84119 -6040 4 15.7306 34.6529 16.8034 2.48832 11.605 -8.49411 -6041 4 17.405 34.6677 17.061 -56.7063 -17.2336 2.19282 -6042 6 40.7477 40.4696 8.51561 8.11488 -8.65224 -15.2287 -6043 4 40.0224 40.6832 9.09702 -8.50867 2.70994 6.70857 -6044 4 40.4514 39.6579 8.0617 2.3787 8.8385 5.97324 -6045 6 42.7444 5.87231 14.2984 24.2128 7.61876 -1.56509 -6046 4 42.0757 5.96647 14.9632 -14.4615 -1.80987 8.42029 -6047 4 42.482 5.17586 13.6922 -11.2697 -3.69634 -0.0191913 -6048 6 14.3614 21.0573 6.06698 -40.3301 2.02826 20.3099 -6049 4 14.5082 21.6099 6.85229 1.25225 -5.13952 -5.68983 -6050 4 15.1941 20.9025 5.67555 35.2665 -1.55979 -15.977 -6051 6 16.3015 37.7733 18.121 -25.7671 9.10936 -15.4408 -6052 4 15.381 38.1761 18.2458 41.2545 -15.1679 7.93486 -6053 4 16.7788 37.6858 18.9587 -11.1023 5.71932 1.62274 -6054 6 40.7984 27.7161 27.1129 -11.0179 0.499807 -0.336913 -6055 4 41.4742 27.2927 27.66 5.56711 1.79851 -1.75817 -6056 4 41.2133 28.334 26.4954 6.67104 -1.0644 4.19578 -6057 6 44.9561 25.991 14.0487 25.7727 -16.7938 -19.0088 -6058 4 45.3739 25.1637 13.7108 -16.5098 12.8855 15.8726 -6059 4 45.5476 26.6442 13.6478 -7.0093 2.51014 3.36733 -6060 6 2.61494 33.9473 21.2474 -9.6198 2.06317 -4.83635 -6061 4 2.13704 34.7904 21.3802 4.44423 -7.12162 -0.559399 -6062 4 2.10703 33.4352 20.5879 2.52794 8.8644 7.26413 -6063 6 5.77575 4.45209 12.8318 1.03208 18.7287 8.08797 -6064 4 5.35339 3.69685 13.2518 -3.06112 -10.1665 -2.69945 -6065 4 5.8052 5.15326 13.507 0.887863 -7.02627 -5.52828 -6066 6 16.8649 5.92112 7.40874 19.9951 -5.29142 4.66315 -6067 4 16.4994 5.07825 7.12483 -4.58221 -9.71617 -5.56506 -6068 4 16.109 6.48147 7.52662 -16.4719 8.95214 3.19539 -6069 6 17.8298 38.4233 36.8534 9.258 40.3096 -0.310058 -6070 4 17.7926 39.4131 36.8935 -6.04129 -19.7424 1.84578 -6071 4 18.5177 38.2893 36.201 1.93535 -10.8086 -1.92368 -6072 6 43.3019 20.5959 5.44166 -6.9278 5.85438 -3.52603 -6073 4 43.1055 21.501 5.07158 -2.97833 -26.833 8.04502 -6074 4 42.4661 20.0651 5.41852 11.3272 16.2867 -2.99003 -6075 6 21.5372 23.2991 30.4448 -14.935 11.2275 -26.3705 -6076 4 20.9947 23.0537 31.1809 -7.12546 -6.28648 20.8256 -6077 4 20.8648 23.582 29.7655 22.6032 -4.28693 10.3415 -6078 6 0.251317 28.0486 36.1651 -22.0243 21.0356 -19.5016 -6079 4 1.02049 27.7114 36.6113 18.9729 -1.47718 6.47801 -6080 4 0.506474 28.8456 35.6445 2.58205 -12.8812 9.00708 -6081 6 3.04678 17.0589 11.5707 1.23946 -7.00965 -18.5436 -6082 4 3.14519 17.2619 12.4977 -1.89892 8.1653 13.6088 -6083 4 2.54959 17.7766 11.1613 1.73961 1.36316 5.23635 -6084 6 24.1645 37.0333 23.9496 -13.0802 10.7124 17.6799 -6085 4 23.6099 37.8384 23.8849 6.1763 -9.33563 -1.28122 -6086 4 24.4663 37.0147 24.8893 -3.58635 -1.49958 -18.3056 -6087 6 3.94341 20.5209 27.4789 6.12038 36.4957 26.1587 -6088 4 3.64002 20.0757 26.7101 -13.0247 -10.3927 -30.3524 -6089 4 3.8213 21.4921 27.3096 0.6263 -21.942 -1.90407 -6090 6 54.8381 2.78983 29.6272 25.3782 12.002 29.7256 -6091 4 54.8259 2.49183 30.5832 -3.08894 8.50949 -25.0172 -6092 4 0.681738 3.33643 29.5869 -23.0163 -14.7319 0.890579 -6093 6 27.1738 8.43221 31.7209 4.37325 44.8318 10.1666 -6094 4 26.7765 8.21235 30.8513 3.34031 12.9925 0.247925 -6095 4 27.4394 9.43578 31.8184 -18.7706 -51.1708 -12.8964 -6096 6 30.9422 1.62815 30.3909 7.68258 9.19266 14.5116 -6097 4 30.6848 0.902997 29.8247 -17.6873 -14.6962 -9.63211 -6098 4 30.1385 1.96768 30.8202 -2.70664 -9.08975 -4.26502 -6099 6 26.4126 36.4396 36.8407 14.7094 2.78685 2.16538 -6100 4 26.1754 35.936 36.0621 -1.37556 -1.6634 -9.1832 -6101 4 27.3614 36.6667 36.7609 -11.9856 -2.56278 0.470716 -6102 6 51.3051 10.055 21.7064 16.9271 -12.7171 -0.47742 -6103 4 50.71 9.38094 22.0984 13.3581 11.7028 -6.50503 -6104 4 52.1297 9.58932 21.3894 -28.6693 12.5934 9.83408 -6105 6 52.4269 12.3712 23.2743 -6.4707 23.0639 13.1163 -6106 4 51.7645 13.1043 23.2119 13.6159 -11.3613 1.42096 -6107 4 52.024 11.6223 22.842 -6.69009 -13.0182 -9.76131 -6108 6 10.0084 38.37 20.6075 21.9453 -2.41338 -4.30271 -6109 4 9.45069 38.2813 21.3825 -6.19229 -0.201962 6.85596 -6110 4 10.9137 38.1225 20.8794 -8.5598 0.614521 -3.9406 -6111 6 22.7031 33.2664 0.640708 10.9794 6.62646 4.85135 -6112 4 23.6679 33.2996 0.582378 1.56947 7.5672 2.73741 -6113 4 22.5144 32.4288 0.230474 -14.5468 -15.5809 -6.04383 -6114 6 14.0917 40.8812 25.4864 9.18744 8.89463 -14.7226 -6115 4 14.196 40.6884 26.4283 -5.63746 -5.20078 0.271339 -6116 4 13.2439 40.5125 25.1796 5.27736 1.6069 9.18822 -6117 6 42.7681 15.0783 14.9763 7.15748 5.71054 -2.59845 -6118 4 43.0785 15.7158 14.2901 -5.10451 -16.9901 16.8665 -6119 4 41.8327 15.2592 15.1092 -5.54173 -0.124331 1.80857 -6120 6 30.2406 7.22111 8.53832 -0.545825 26.9265 -4.64375 -6121 4 30.1758 8.19473 8.52708 -1.1145 -9.52086 -16.9196 -6122 4 30.4024 7.07989 9.45321 5.06633 -17.0605 24.2519 -6123 6 3.37759 19.8423 41.3077 23.4194 0.89426 -0.123069 -6124 4 3.19865 19.3681 40.4829 0.842743 3.23829 1.04749 -6125 4 4.34953 20.0012 41.2688 -20.407 -4.57585 2.1738 -6126 6 8.87423 25.1354 17.2017 -10.0567 -4.23249 -18.7298 -6127 4 8.96932 24.947 16.2256 5.94886 2.92938 28.6011 -6128 4 9.65182 24.8278 17.6915 0.0257745 -5.63434 -9.64419 -6129 6 9.32494 14.9555 22.0283 -12.5325 4.5599 7.62514 -6130 4 9.01993 14.8718 22.9489 -0.27625 1.365 -7.1979 -6131 4 10.1958 14.5523 22.0148 2.38734 -2.44115 -2.54227 -6132 6 2.03086 4.7751 20.8592 -0.302533 -25.5342 -8.8148 -6133 4 2.76807 5.37577 20.9697 7.90436 11.3601 5.00545 -6134 4 1.2576 5.15949 21.2703 -7.54078 11.376 6.7073 -6135 6 18.2964 7.06718 3.86051 -0.633466 1.54328 39.8902 -6136 4 18.916 7.22135 3.16498 20.2468 5.35447 -22.1173 -6137 4 18.8081 6.54637 4.52758 -12.8964 10.087 -8.61721 -6138 6 17.0178 19.1734 19.8425 8.05121 8.342 4.19715 -6139 4 17.786 18.9037 19.3194 -9.06534 -4.96345 -2.22737 -6140 4 16.269 18.585 19.6427 11.1227 0.819232 -3.01639 -6141 6 4.30363 6.55267 21.3463 7.67654 -0.43578 -3.38259 -6142 4 4.33009 7.06923 20.5107 4.36212 -5.74714 10.2686 -6143 4 5.22777 6.26626 21.5669 -20.6993 9.2157 -12.5452 -6144 6 20.7848 36.9284 35.662 4.03453 1.95325 3.7669 -6145 4 20.2254 37.0836 34.8976 -2.25577 1.87165 -3.27163 -6146 4 20.2383 36.4327 36.2875 0.848364 -0.11832 4.44878 -6147 6 4.7306 15.0205 31.2333 -1.91968 -20.8619 8.65585 -6148 4 4.4229 14.7734 32.1398 6.18773 10.2906 -17.1472 -6149 4 4.73385 15.973 31.1263 -2.35963 8.87481 4.31723 -6150 6 2.35358 1.22877 17.5767 10.9459 -8.92502 -6.22121 -6151 4 3.05741 1.28614 16.8672 -19.772 5.07478 19.7417 -6152 4 1.94409 2.09607 17.7592 7.86728 -5.07336 -5.26938 -6153 6 34.6221 31.5613 19.8029 0.0167231 -1.91103 -0.857839 -6154 4 35.0026 31.8698 18.9629 1.12657 -3.13716 4.28436 -6155 4 34.4223 32.3623 20.3103 -0.485441 0.265221 -3.01806 -6156 6 24.1912 21.6103 13.5173 31.6251 8.72647 13.7111 -6157 4 25.0921 21.8731 13.8418 -25.6554 -7.43575 -12.369 -6158 4 23.5893 22.1875 13.984 -2.65104 7.77201 2.87587 -6159 6 37.2187 41.0834 5.69361 1.76676 -13.0415 -0.936073 -6160 4 37.8761 41.7354 5.91144 16.7665 3.57334 0.125879 -6161 4 36.4089 41.5349 5.88363 -19.4064 5.82624 -1.33385 -6162 6 8.4323 8.00063 20.2395 28.2224 -17.334 -6.20124 -6163 4 9.29892 8.115 20.6547 2.73811 -3.60152 -0.447724 -6164 4 7.94828 8.69862 20.6224 -29.3938 29.4062 12.6481 -6165 6 14.9357 18.8843 36.7618 11.8158 33.7978 0.271425 -6166 4 14.1259 19.2123 36.362 -3.40669 -6.42507 -0.135577 -6167 4 15.5651 19.6361 36.6422 -7.52364 -17.7077 5.06346 -6168 6 43.9725 40.6444 18.6569 4.16672 -2.33153 16.0012 -6169 4 43.9166 40.834 17.7203 0.682613 4.51617 -13.4207 -6170 4 44.9212 40.6761 18.9032 -12.0211 -3.47257 -3.21486 -6171 6 33.7852 32.2494 37.3449 -11.8504 2.76306 -14.1758 -6172 4 34.0177 32.2775 36.4055 -1.41242 -0.232407 11.1732 -6173 4 34.3686 31.6236 37.7745 10.7747 -2.06792 3.13276 -6174 6 5.09749 29.2901 24.0356 16.7213 -6.5526 19.7529 -6175 4 5.77222 29.487 24.7328 -11.5239 -2.29901 -14.2657 -6176 4 4.7684 30.1321 23.7215 -1.73734 11.0072 -2.10513 -6177 6 33.6153 36.4198 10.9805 1.47517 3.52666 5.33615 -6178 4 32.7579 36.4403 10.5596 -3.06779 3.10292 -7.60642 -6179 4 33.384 36.4828 11.91 5.71512 -0.747971 7.16991 -6180 6 28.3006 33.5952 13.1115 6.62888 -15.4249 13.7129 -6181 4 27.948 33.7778 12.2398 -4.56551 -8.24283 -4.77521 -6182 4 28.1705 32.6462 13.2914 -0.364449 12.3294 -7.26248 -6183 6 6.16378 19.058 24.2919 3.99573 -9.29146 -27.7059 -6184 4 6.01812 19.825 24.8144 -3.49512 27.1397 16.8881 -6185 4 6.29927 18.3335 24.8859 3.7649 -20.2974 16.0908 -6186 6 28.4267 19.9356 1.8581 6.30761 1.98196 1.30153 -6187 4 28.5945 19.3745 1.10227 -2.74725 -9.675 -9.29711 -6188 4 29.2893 20.1184 2.23075 1.76934 5.71608 2.57016 -6189 6 42.0557 23.969 9.55925 -0.174378 -1.97525 4.49576 -6190 4 42.3037 23.8044 10.4694 5.92504 9.79373 11.5418 -6191 4 41.7282 23.1152 9.29053 -8.19873 -12.6145 -11.7634 -6192 6 43.5187 7.30226 27.4319 7.08124 -12.3985 0.368771 -6193 4 42.7424 7.14751 27.9838 -5.23639 1.01312 3.8871 -6194 4 43.2552 7.97753 26.8025 -4.71413 8.37143 -8.21745 -6195 6 20.4824 33.0041 9.27291 -32.573 -27.3267 34.6611 -6196 4 19.7824 32.5876 9.93875 35.2414 32.5831 -36.6535 -6197 4 20.3431 33.9616 9.1663 -10.2228 -2.75758 9.24016 -6198 6 38.0326 35.2526 15.9362 -7.94884 -19.6622 -5.99631 -6199 4 37.3459 34.9971 15.2894 4.63074 2.95951 5.93375 -6200 4 37.9463 34.6017 16.6504 2.45283 5.99568 -2.76115 -6201 6 47.5301 20.8853 3.96175 -5.34824 -5.66637 20.3565 -6202 4 47.9759 21.3648 3.2498 -4.9297 7.97101 8.48596 -6203 4 47.5029 21.3928 4.81786 6.75175 -1.3172 -26.6206 -6204 6 10.9933 31.6966 41.4271 11.47 5.02521 -0.853614 -6205 4 11.6392 31.7665 40.7132 0.112137 -5.28149 3.10577 -6206 4 10.1353 31.6993 40.998 -8.62143 -0.203152 -1.66696 -6207 6 43.2403 12.6562 2.57215 9.62694 -8.68348 -18.5989 -6208 4 42.9077 12.993 3.39384 -2.38679 2.43178 19.528 -6209 4 44.033 12.1261 2.78242 -8.9232 8.2725 3.71991 -6210 6 49.4204 25.4105 21.1683 5.59269 -12.2048 -2.72561 -6211 4 50.0196 25.2987 20.4097 -7.64964 4.29225 2.01473 -6212 4 48.8877 24.5919 21.195 1.69169 7.44836 1.02425 -6213 6 1.95674 34.1403 26.4747 8.8762 -24.2704 6.47661 -6214 4 2.77674 33.6103 26.5537 -12.4269 14.6955 -4.62849 -6215 4 1.26657 33.4613 26.3994 -1.21739 9.31774 -1.03397 -6216 6 17.1306 20.8229 36.6851 -31.9931 14.1441 13.8122 -6217 4 16.9533 21.7471 36.9985 5.62896 -19.6931 -5.93312 -6218 4 18.0634 20.696 36.5868 23.783 -2.64609 -3.70934 -6219 6 36.6048 10.9866 3.71548 -5.44552 8.31799 24.2539 -6220 4 35.7423 11.3886 3.87785 -5.6936 5.55042 -13.8219 -6221 4 36.8135 10.7077 4.61447 10.9535 -7.59336 -0.361553 -6222 6 14.2169 20.6838 21.9439 11.6961 23.12 -6.3106 -6223 4 13.8085 20.2376 21.1912 1.98746 8.13024 -7.83415 -6224 4 14.8103 21.4259 21.6461 -14.674 -27.097 -1.82439 -6225 6 33.9151 12.2544 9.54899 39.8857 -26.0408 -21.0892 -6226 4 34.3088 11.5163 10.0208 11.0461 -3.70138 -11.6499 -6227 4 33.2997 12.4814 10.1903 -47.9458 31.9244 32.2008 -6228 6 21.8056 41.4836 2.15686 0.64336 -1.87746 -8.80618 -6229 4 22.0354 41.6672 1.22189 -5.57638 1.91412 12.8342 -6230 4 22.5122 40.9391 2.50884 5.16687 -0.375256 0.644554 -6231 6 20.9282 10.4547 14.1996 25.019 -0.0729632 25.5582 -6232 4 21.5922 10.842 14.8375 -21.0894 -6.80718 -21.5316 -6233 4 20.826 9.54084 14.5456 -0.887825 12.9084 -9.51249 -6234 6 6.24616 4.45231 24.6293 -10.9468 0.993291 2.39826 -6235 4 6.83688 4.17894 23.9311 12.242 -0.137787 -14.9911 -6236 4 5.68087 3.68408 24.7586 -3.59028 -1.51582 -1.5433 -6237 6 50.784 14.5954 23.4824 21.8736 9.84292 5.60122 -6238 4 51.2681 15.1205 24.1582 -9.03857 -7.6656 -10.4761 -6239 4 49.9341 14.3608 23.8519 -7.60536 -4.54693 6.65168 -6240 6 52.7678 13.9144 9.68214 -3.90955 36.1598 -0.40974 -6241 4 52.8738 13.0144 9.92216 4.47335 -34.5538 7.53363 -6242 4 51.8729 14.0092 9.35938 -14.036 0.105332 -6.17221 -6243 6 9.05048 2.05234 29.9152 -29.3842 -12.1538 -14.6176 -6244 4 9.42756 2.83336 30.2687 13.3628 24.1087 13.7335 -6245 4 8.09173 2.26823 29.8032 18.9866 -6.39081 0.174186 -6246 6 7.13499 29.9757 26.2377 7.52656 -33.046 2.78556 -6247 4 6.52748 30.39 26.8607 -0.20976 -1.88395 4.87081 -6248 4 7.49713 29.1538 26.6869 -11.4544 24.9502 -11.4644 -6249 6 49.1541 41.742 14.3355 11.4439 21.5488 -10.6063 -6250 4 49.5333 41.2573 13.5835 -2.72613 -5.13007 3.47372 -6251 4 49.526 0.750494 14.2401 -8.50163 -23.9907 2.80869 -6252 6 5.64545 3.82333 19.1929 -5.43924 -10.1162 19.2647 -6253 4 5.12472 3.39384 19.906 6.51959 7.46947 -11.8792 -6254 4 5.07872 3.8651 18.4273 -3.31865 2.78603 -7.74707 -6255 6 9.32747 35.8381 24.9081 -3.67476 7.0144 6.61099 -6256 4 10.2167 35.7622 24.5243 -1.5306 1.39279 3.84516 -6257 4 9.42305 36.4736 25.6393 1.10498 -0.920313 -3.33942 -6258 6 53.0258 29.7567 11.5493 -1.29773 -2.97991 8.71205 -6259 4 53.4398 30.4104 10.9769 2.6525 4.63524 -3.89524 -6260 4 52.8324 30.2122 12.386 1.27544 -1.91261 -4.55584 -6261 6 22.6082 9.97702 5.69106 1.45951 -2.04334 43.7981 -6262 4 23.4598 10.2484 6.09617 -7.85329 -3.83944 -13.5574 -6263 4 22.5497 10.2693 4.79236 2.60512 5.60546 -21.7219 -6264 6 39.5532 19.6216 2.68726 -3.50035 -14.5445 -22.3968 -6265 4 38.6563 19.3067 2.54039 -1.65167 0.121811 17.9309 -6266 4 39.9003 19.405 1.80953 18.3116 7.78412 6.67062 -6267 6 45.082 35.5833 7.81025 20.3465 -2.3491 -25.2688 -6268 4 45.1219 36.3229 8.40611 -5.73741 11.9797 15.8104 -6269 4 44.452 34.9332 8.12016 -12.4923 -3.86067 9.83054 -6270 6 29.7976 14.244 9.96067 -5.32248 -4.64296 1.12628 -6271 4 30.0443 14.0971 9.02808 -4.18819 -1.64606 2.67632 -6272 4 28.8444 14.0269 10.0606 18.5465 4.64021 -4.02524 -6273 6 29.2523 30.155 21.8932 -5.77992 6.30922 3.94049 -6274 4 29.1431 30.8143 21.21 -7.42967 10.4849 -3.0507 -6275 4 30.0153 29.6632 21.6201 11.6336 -14.2167 -2.13367 -6276 6 11.1107 18.8213 6.56056 -14.6836 -1.88929 0.635516 -6277 4 11.166 19.7501 6.27543 7.98891 -2.6539 -0.194038 -6278 4 11.9915 18.4225 6.59495 6.41359 9.14832 -2.51569 -6279 6 13.4142 39.1371 13.4638 17.7807 -10.3765 -23.6259 -6280 4 13.7831 39.7975 14.0449 5.16656 9.87024 9.85065 -6281 4 12.6066 38.8468 13.8734 -16.0883 -5.26763 6.93978 -6282 6 50.1521 12.9948 0.13749 23.7903 11.3983 42.7862 -6283 4 49.8531 12.6437 41.2486 -17.3674 -16.2897 -43.7514 -6284 4 50.6811 12.2823 0.528204 -2.61001 5.26075 1.59628 -6285 6 47.8279 31.3538 27.7873 0.535952 -14.579 -21.2406 -6286 4 47.8981 31.8966 28.5732 -11.876 9.28639 5.42067 -6287 4 46.9879 31.5201 27.3031 12.1261 3.81279 14.9113 -6288 6 27.708 1.63283 7.49454 14.1634 -3.44528 -21.3886 -6289 4 26.9442 1.71926 8.04828 -16.4795 3.87106 10.0363 -6290 4 27.4331 1.03137 6.77318 -2.44435 3.14912 6.58235 -6291 6 54.8843 20.7912 16.041 -0.591057 -23.5277 -19.4313 -6292 4 54.9506 20.9946 16.9763 2.49267 -3.51754 11.2958 -6293 4 0.215527 19.8591 15.8725 -6.64294 24.8159 10.1677 -6294 6 37.4309 32.9919 34.4461 -3.01999 17.5498 0.613574 -6295 4 37.2599 32.074 34.6492 -8.98721 -14.1314 1.69718 -6296 4 36.602 33.3843 34.0789 10.8556 -9.90957 7.57788 -6297 6 19.516 39.775 6.74949 1.2991 -23.719 -0.568837 -6298 4 19.1628 39.2461 5.9771 11.6696 10.1577 21.4746 -6299 4 19.8715 39.1258 7.41882 -10.6166 14.587 -19.1486 -6300 6 32.439 2.74298 8.0597 2.15016 14.1028 28.0311 -6301 4 32.8474 3.04427 8.91221 -2.20578 -4.83758 -21.9226 -6302 4 31.6043 2.37221 8.38063 -2.27075 -4.50389 -9.9889 -6303 6 12.9757 16.0783 4.05517 0.782156 -17.4841 -11.0101 -6304 4 12.5393 15.6612 4.81952 2.97976 0.136191 -5.67644 -6305 4 13.3707 15.3387 3.55371 -3.64889 7.0956 8.52646 -6306 6 4.65115 29.9533 5.41887 4.80886 14.2508 -32.4371 -6307 4 5.0407 30.2031 4.52094 -17.5959 -12.1853 28.663 -6308 4 3.95879 29.263 5.26663 23.43 17.9812 0.878069 -6309 6 29.754 32.1152 24.0535 7.2798 7.01713 3.37681 -6310 4 30.6602 32.1649 24.4187 -11.1956 -0.828668 -6.39664 -6311 4 29.7572 31.4388 23.3746 -2.03067 -7.97912 -3.55015 -6312 6 11.8649 30.6972 33.4692 4.66278 -43.8766 26.3819 -6313 4 11.8723 29.8544 34.0435 -6.78391 38.5593 -23.2698 -6314 4 12.7601 30.7129 33.1118 -0.162199 2.5806 0.32685 -6315 6 17.3589 40.4121 27.3072 22.6925 26.1242 -9.80885 -6316 4 17.3318 41.3765 27.4299 10.8839 -2.3351 -5.50809 -6317 4 16.5554 40.1462 27.6883 -41.5002 -17.3681 16.6281 -6318 6 8.67113 4.89706 8.92484 12.0335 -9.87957 -4.1983 -6319 4 8.33733 5.39218 8.1724 -5.0195 2.6367 -1.72337 -6320 4 8.22391 5.22927 9.70847 -2.49168 4.71619 2.25155 -6321 6 39.5722 17.6819 9.57834 18.7012 -23.4437 -36.958 -6322 4 39.2207 17.6668 10.4653 -7.32211 -9.11094 11.7967 -6323 4 39.6226 16.7555 9.16114 -8.90732 35.1542 21.3272 -6324 6 31.4906 30.1663 28.5669 -18.2413 -3.40307 10.1233 -6325 4 32.2933 30.4252 28.099 2.93126 -8.695 5.25695 -6326 4 31.6493 29.3506 29.0723 8.50077 6.58979 -7.17605 -6327 6 52.667 19.2904 40.0609 -3.10376 4.72625 -3.48654 -6328 4 52.9542 18.5867 39.4362 -2.88314 13.2503 8.01058 -6329 4 53.0181 20.1618 39.7754 -0.243354 -8.89628 -7.05583 -6330 6 3.24103 7.80987 9.85575 15.4795 13.9798 -0.387217 -6331 4 3.75934 8.59525 10.1836 -13.0283 -21.6848 -11.3123 -6332 4 3.84189 7.30622 9.27659 -5.58147 6.91981 6.81825 -6333 6 23.1336 35.2172 35.587 -21.8844 -14.3383 30.559 -6334 4 23.8289 35.3646 34.9695 18.2116 12.6911 -23.5817 -6335 4 22.438 35.8962 35.5045 5.76256 0.966742 -5.52301 -6336 6 19.4997 14.0668 20.8253 -20.4482 -5.33672 -12.8711 -6337 4 19.9465 14.5101 21.5526 -0.10572 6.16799 9.82761 -6338 4 18.517 14.0876 20.9737 19.1914 1.01522 3.6393 -6339 6 23.6166 15.8675 24.0247 18.6101 -11.8924 -11.0295 -6340 4 23.7056 16.8159 24.0204 -5.88143 19.7526 4.0278 -6341 4 24.4592 15.5679 23.6279 -14.5441 0.474754 5.50536 -6342 6 0.271665 30.4941 6.10208 19.3679 10.4089 38.3983 -6343 4 55.0639 30.1609 5.24948 -13.9023 -9.5098 -30.2095 -6344 4 54.47 30.83 6.54681 -8.02886 -2.57547 -7.81581 -6345 6 4.88814 13.205 29.1223 -11.8587 -43.2127 -22.2411 -6346 4 4.78002 13.8458 29.7909 -3.08187 32.2273 31.1649 -6347 4 5.63816 13.4614 28.593 12.4558 6.3486 -8.85318 -6348 6 54.2078 27.2696 19.1963 -15.9712 -23.151 25.2067 -6349 4 0.0774591 27.3551 19.591 11.6552 0.895327 2.86932 -6350 4 54.2345 27.7605 18.3958 2.66703 17.7524 -27.3595 -6351 6 13.918 35.7451 9.18145 -1.78919 -38.7722 -17.1362 -6352 4 13.6805 34.9997 8.54227 8.11159 28.2534 18.027 -6353 4 13.9675 36.5302 8.63631 -0.993585 8.08981 -9.4946 -6354 6 5.91273 31.9181 18.8024 -12.4461 1.37758 17.74 -6355 4 5.51416 32.8097 18.9023 4.86685 -6.68339 -12.1033 -6356 4 6.30341 31.7597 17.9414 -1.0189 10.0948 -10.5031 -6357 6 5.79665 28.8753 9.48388 1.22923 1.68801 -9.18455 -6358 4 5.13151 29.3325 10.0083 -4.81051 1.68465 1.48607 -6359 4 5.29369 28.2634 8.9143 2.26517 5.17431 2.85494 -6360 6 40.1173 6.05944 9.72118 13.8961 -11.6659 -14.1698 -6361 4 40.0092 6.65032 8.94634 5.33155 -13.6 11.5113 -6362 4 40.8322 5.39707 9.49335 -23.1878 23.6737 0.508505 -6363 6 20.33 13.449 41.3936 11.1096 -0.534149 -19.18 -6364 4 21.2311 13.7006 41.7531 -26.0398 -5.61362 -19.048 -6365 4 20.2547 13.6822 40.4168 8.50391 -3.95591 26.8537 -6366 6 14.4455 21.736 27.3642 10.1345 -2.11962 18.0607 -6367 4 15.3888 21.7922 27.5976 -10.3958 0.0660495 -7.924 -6368 4 14.3649 21.6255 26.4124 4.42937 0.724974 -0.20238 -6369 6 38.7561 1.79551 30.0553 7.9914 -17.3849 -15.575 -6370 4 38.4573 2.01955 30.9195 -8.42419 6.13431 27.6354 -6371 4 38.9299 2.64677 29.6557 3.10695 8.29419 -8.65227 -6372 6 5.60526 10.8558 14.1801 -12.7318 -17.5226 5.68918 -6373 4 4.9397 11.5438 14.0518 -0.153792 0.369728 -2.18729 -6374 4 5.10481 10.0791 14.5379 11.5553 16.0131 -9.09073 -6375 6 45.3957 36.7129 27.9145 12.4213 23.5208 -28.0365 -6376 4 46.0624 36.7782 28.6036 -4.12954 -6.22049 8.27184 -6377 4 45.8092 37.2197 27.1638 -19.7894 -19.9635 17.4029 -6378 6 54.0798 35.0308 20.3994 -2.843 -1.86615 -11.5734 -6379 4 53.8804 34.0877 20.4832 1.52986 -2.36109 -0.337181 -6380 4 53.937 35.2424 19.4598 0.882668 -0.831705 10.9264 -6381 6 42.0694 14.2202 28.4717 21.1483 -3.98018 21.7174 -6382 4 41.9885 13.9669 29.4143 -10.3093 2.59547 -11.4583 -6383 4 43.02 14.3987 28.405 -3.82604 1.35242 -7.96462 -6384 6 34.8498 7.69636 26.7062 10.2576 -3.81921 3.94078 -6385 4 35.6291 7.30563 27.124 0.895866 5.46509 7.50645 -6386 4 34.5698 7.0105 26.0965 -7.64543 -1.95318 -6.87837 -6387 6 49.6738 30.7035 23.8555 -19.3272 -4.41511 -13.3992 -6388 4 50.4901 31.166 23.8286 28.3544 13.2291 -0.764283 -6389 4 49.8241 29.9642 24.4268 4.30872 -17.0733 16.2757 -6390 6 50.9008 7.796 14.1645 9.55664 -5.64416 8.78132 -6391 4 50.8079 7.01141 13.6383 2.57079 -23.1487 -4.84087 -6392 4 50.5017 8.45024 13.6177 -13.1237 27.0593 -11.2067 -6393 6 4.26801 39.4668 27.8349 5.05862 -9.29033 0.915363 -6394 4 3.69733 40.2352 27.9464 -2.13812 3.43039 0.251988 -6395 4 3.85787 38.9439 27.1453 -8.48589 -4.99062 -8.23097 -6396 6 8.74801 32.8245 8.20645 -16.3778 -23.5545 -4.64115 -6397 4 8.1587 32.1369 7.77132 15.1044 25.0089 5.08958 -6398 4 8.83862 33.6223 7.65804 -4.44885 -3.27239 -3.39484 -6399 6 52.9644 25.4956 9.38778 -23.0628 41.5097 8.07386 -6400 4 51.9653 25.4466 9.50894 36.2156 4.27363 -7.84863 -6401 4 53.1697 26.4737 9.50477 -8.20239 -39.1491 -3.41364 -6402 6 29.5595 36.7246 19.4744 18.9803 -2.04176 16.4704 -6403 4 29.6949 37.303 18.726 -4.20274 3.37351 -9.90607 -6404 4 30.4598 36.6303 19.854 -15.3589 -5.02994 0.251134 -6405 6 52.32 36.0811 25.1124 8.57954 -21.5781 -32.5589 -6406 4 53.081 35.9362 25.6725 3.50304 3.9365 6.54391 -6407 4 51.6308 36.4579 25.6293 -16.5409 10.2166 18.3955 -6408 6 21.1806 15.7021 31.1799 -1.73968 4.64344 -14.8668 -6409 4 20.7524 16.2958 30.5301 6.89899 -9.15256 14.6363 -6410 4 20.4997 15.2544 31.7027 -1.32541 3.0922 -5.22806 -6411 6 10.6615 22.4234 39.4446 2.77058 -10.3375 -21.7461 -6412 4 10.8237 22.5242 38.4595 -6.54577 -4.89624 27.0726 -6413 4 10.2823 21.5329 39.6036 8.10661 10.4602 -7.72978 -6414 6 25.1119 11.6683 22.7275 17.9584 10.1803 -43.002 -6415 4 25.2932 11.5881 23.6503 -10.3644 -4.73542 30.1579 -6416 4 24.2275 11.4525 22.4127 -3.04384 -6.16919 15.0614 -6417 6 31.7847 10.4664 2.90738 14.6232 4.92747 -25.5509 -6418 4 32.6367 10.8084 3.16838 3.35352 3.27745 17.8769 -6419 4 31.9203 10.4929 1.94425 -15.217 -5.45404 8.94289 -6420 6 52.4827 36.4345 22.1596 -7.80713 -36.8893 3.58418 -6421 4 53.0619 36.0081 21.4904 -7.85296 7.00584 7.09748 -6422 4 52.1113 35.6558 22.6625 11.8438 27.843 -13.8236 -6423 6 46.2218 40.0356 27.0002 3.00948 19.3103 18.0239 -6424 4 46.4695 39.2891 26.4839 7.60887 -23.2108 -12.3358 -6425 4 45.8298 40.6551 26.3816 -4.98516 2.75312 2.41297 -6426 6 24.0859 36.731 39.1057 28.0861 3.14637 -13.7231 -6427 4 23.7868 35.8298 38.9338 -5.18553 -0.74556 5.28182 -6428 4 23.4629 37.185 39.6652 -17.6872 -1.49015 10.8999 -6429 6 22.3474 7.42423 31.8108 -22.1464 -34.764 6.81692 -6430 4 22.3426 8.34479 32.0749 -0.491553 12.3501 5.32307 -6431 4 21.6443 6.94951 32.3421 24.5486 22.6275 -17.4273 -6432 6 14.3601 18.3609 4.10227 -5.91068 -17.6869 34.0105 -6433 4 14.0198 17.4467 4.00899 4.58845 16.3972 -3.13031 -6434 4 14.1964 18.4938 5.07185 10.0688 2.42213 -23.7444 -6435 6 27.3176 38.4584 0.118061 26.6324 1.72941 22.4386 -6436 4 26.8721 39.2229 0.514978 -6.24738 0.955789 -1.68833 -6437 4 28.1825 38.4197 0.615747 -27.5588 -2.17115 -12.0629 -6438 6 18.6641 0.153005 12.2455 -30.1585 11.9093 7.70812 -6439 4 17.6838 0.288413 12.4195 29.795 -10.6896 -3.23208 -6440 4 18.9224 41.3021 12.7767 -6.14336 -8.14908 8.56265 -6441 6 49.4289 24.9791 25.34 -2.93287 6.40986 -7.21031 -6442 4 48.5336 24.6845 25.5066 -4.79022 -10.2209 3.00881 -6443 4 49.2657 25.7332 24.7569 10.0796 0.538989 -0.302405 -6444 6 52.0657 20.2866 15.752 -30.988 -5.77477 12.2451 -6445 4 52.9883 20.4648 15.7877 30.7647 6.19501 2.10932 -6446 4 51.7487 20.318 16.6754 2.59628 0.707672 -8.61894 -6447 6 49.6694 15.6466 38.5033 -2.36871 5.8496 0.21755 -6448 4 49.1634 15.9354 37.7317 2.81773 -6.75889 -8.88584 -6449 4 49.3364 16.2327 39.1899 -1.1635 1.82265 11.9188 -6450 6 15.9209 23.7098 13.4125 14.0576 3.0382 28.6395 -6451 4 16.4576 23.7581 14.2247 -6.14337 -14.5589 -15.9509 -6452 4 15.4928 24.5639 13.4473 -12.8057 7.70559 -12.0572 -6453 6 14.3535 29.1644 14.3158 -5.44214 8.41065 -10.6214 -6454 4 14.1107 29.5404 13.4323 4.3831 -8.60004 22.5031 -6455 4 14.1668 29.874 14.9595 1.02369 -3.68708 -8.8215 -6456 6 30.4209 19.8501 16.8941 13.513 -29.8099 -4.40702 -6457 4 30.8419 19.6061 17.7309 -1.16118 4.00396 0.0836579 -6458 4 29.8867 20.6126 17.0073 -13.0379 22.0094 6.56408 -6459 6 21.3171 21.0315 23.1347 13.77 4.04154 19.3244 -6460 4 22.2214 21.2364 23.4619 -15.8088 -1.32345 -6.31481 -6461 4 20.7299 21.1568 23.8987 5.07857 1.54253 -3.54042 -6462 6 32.3393 0.431439 25.2563 20.1104 -9.0179 2.05206 -6463 4 32.3376 0.357033 24.2893 -5.83171 4.85221 4.50445 -6464 4 31.4939 0.740536 25.5658 -20.5297 5.12544 -3.04931 -6465 6 26.1412 32.4208 27.5133 11.9844 8.82666 12.5058 -6466 4 25.6297 33.2181 27.3271 -3.7928 0.326337 -6.17907 -6467 4 25.9506 31.7475 26.8638 -6.12498 -3.36782 -14.5181 -6468 6 31.6886 23.0183 41.4596 0.904697 7.64904 11.3452 -6469 4 32.5758 22.6752 41.6838 -11.075 0.532718 -2.08438 -6470 4 31.0649 22.7115 0.227606 5.71652 1.16966 -4.3825 -6471 6 54.3662 17.838 10.7289 1.16641 13.6113 28.4031 -6472 4 53.5784 18.2682 10.4091 -15.835 11.3767 1.3744 -6473 4 54.5574 17.2244 10.05 12.0924 -25.2322 -22.7117 -6474 6 15.4007 28.5656 8.62044 -26.1749 5.76845 -41.3303 -6475 4 14.7273 28.9702 8.01425 13.7656 -2.21873 23.1298 -6476 4 15.8479 27.9621 8.001 5.22436 1.48231 12.0756 -6477 6 21.9302 22.318 27.6758 1.68517 -22.7815 -10.3197 -6478 4 22.2029 23.2377 27.6948 5.32233 7.77922 8.4028 -6479 4 21.9507 21.9579 28.5708 1.77406 4.33165 6.10734 -6480 6 2.9439 17.0434 8.14058 1.94164 -24.3442 -12.3304 -6481 4 3.71771 17.0381 7.53295 -10.9103 8.58946 10.7103 -6482 4 2.9095 17.8301 8.67828 12.1388 15.179 1.9509 -6483 6 27.5776 18.2769 3.9771 26.0492 -34.2565 5.18616 -6484 4 26.8914 18.9079 3.85686 -19.1066 25.6869 -8.0303 -6485 4 28.3968 18.6065 3.57961 -12.2542 3.89161 2.52414 -6486 6 24.7648 24.5394 8.45172 0.675902 5.99664 -6.73781 -6487 4 25.0691 23.6382 8.29185 0.995795 -2.08458 0.0885467 -6488 4 24.6379 24.6158 9.40394 1.7631 1.80546 -0.516948 -6489 6 41.9985 30.4652 13.7873 -12.418 22.2399 8.0521 -6490 4 42.948 30.5766 13.6065 -4.54142 -18.1038 -0.632901 -6491 4 41.6543 29.5567 13.7855 17.2179 -0.450275 -1.52495 -6492 6 15.7003 34.688 41.5836 22.5583 -4.71252 2.77114 -6493 4 16.4414 35.3131 41.7067 -7.89455 1.74939 1.29748 -6494 4 14.9091 35.1782 41.7999 -10.5684 8.94915 5.66738 -6495 6 11.14 19.7709 40.5827 8.16812 -24.8495 -13.7269 -6496 4 12.099 19.6958 40.4335 -6.97557 5.6239 6.72769 -6497 4 10.8269 18.8658 40.3418 -4.09458 16.1616 8.77151 -6498 6 47.4994 34.5266 14.3059 -7.29954 -13.2064 -47.3862 -6499 4 46.9486 35.2618 14.0194 -1.26876 14.2822 14.9014 -6500 4 47.5134 34.0178 13.447 14.161 -1.19014 30.6955 -6501 6 12.4113 26.9599 28.4986 7.53387 -39.615 -11.3807 -6502 4 13.2389 26.8759 29.0383 -9.69033 -7.26437 -10.917 -6503 4 12.3547 26.143 27.8911 8.77392 33.3418 27.7102 -6504 6 27.6324 16.2078 39.8226 -15.7166 38.3334 10.2244 -6505 4 27.1738 15.4871 40.2515 -0.529449 -16.0233 0.418904 -6506 4 28.2783 15.8881 39.2072 13.4358 -18.0852 -11.4488 -6507 6 33.41 31.2223 27.2648 1.06056 32.1352 -34.8736 -6508 4 34.1408 31.8147 27.4795 4.37007 -7.45055 8.12396 -6509 4 32.9956 31.7298 26.5244 2.74339 -19.701 12.9858 -6510 6 39.1079 39.5697 31.9277 -2.55925 2.09297 0.92959 -6511 4 38.7672 39.6549 31.0188 2.43701 -1.71218 7.87361 -6512 4 38.6143 40.212 32.4659 5.60044 -5.69156 -1.85126 -6513 6 22.8777 16.5449 19.9566 -5.65986 -8.80894 -1.36967 -6514 4 23.3352 15.8067 20.4264 -14.7096 4.17994 -10.0586 -6515 4 22.0919 16.2116 19.4632 15.4216 -6.99735 9.66589 -6516 6 23.9693 21.8661 10.5894 -36.2244 3.36606 3.40233 -6517 4 22.9782 21.9097 10.6297 20.8239 3.29656 -5.85881 -6518 4 24.1356 21.2379 11.286 10.3432 -8.66819 12.8402 -6519 6 40.1777 25.441 2.79106 -10.2872 18.2283 6.37262 -6520 4 40.1705 25.0132 3.63888 8.49445 -17.5146 10.0011 -6521 4 39.7592 26.2809 3.01477 -1.02299 2.45309 -8.63041 -6522 6 15.0237 19.7749 9.41859 -29.0071 17.4399 5.80075 -6523 4 14.7228 20.7104 9.1599 7.38 -34.1593 9.70733 -6524 4 14.2459 19.2857 9.84339 25.5779 21.3804 -17.4983 -6525 6 7.16152 24.8628 0.123297 -7.02966 -3.56682 11.7049 -6526 4 7.96668 24.8036 41.5398 15.214 -7.46464 -23.6733 -6527 4 7.46323 25.2953 0.914133 -6.27594 4.44234 13.0485 -6528 6 43.3927 10.9201 31.3407 25.4071 10.106 7.84859 -6529 4 43.8098 10.8609 30.45 -7.40798 -0.791197 19.4909 -6530 4 44.1598 10.9733 31.9767 -21.009 -0.343387 -21.8186 -6531 6 13.8353 19.068 27.8558 -6.19586 12.3763 0.85665 -6532 4 12.975 18.7858 28.1864 -1.64107 2.23065 2.52451 -6533 4 13.8413 20.053 27.8412 2.88957 -13.8419 -2.19198 -6534 6 3.4728 19.5924 9.6022 -44.5705 9.69836 1.75794 -6535 4 2.70361 20.0095 10.0844 20.5969 -13.9146 -9.89239 -6536 4 4.25765 19.8234 10.0844 13.5534 0.0599395 5.99295 -6537 6 51.0213 19.4268 7.70955 2.43945 12.0622 -23.2725 -6538 4 50.6325 20.2627 7.28999 21.6228 -31.5555 10.1722 -6539 4 51.8004 19.115 7.16203 -27.7652 18.9123 7.69536 -6540 6 42.2139 2.59999 10.4154 11.3377 -7.01405 -0.847173 -6541 4 43.144 2.57533 10.7556 -19.516 1.89174 -10.2127 -6542 4 42.1979 2.39197 9.45142 9.27815 6.14572 20.7298 -6543 6 30.7794 6.42968 35.1975 -13.4378 -7.3385 -2.08895 -6544 4 29.8146 6.43175 35.3648 9.73054 -4.02703 -1.93701 -6545 4 31.052 5.50707 35.0427 -6.67101 6.52405 0.860042 -6546 6 52.8733 36.9495 18.5906 -4.95733 10.1612 -6.16245 -6547 4 51.9909 36.5548 18.5738 -2.549 -5.51132 1.40056 -6548 4 52.7192 37.8514 18.247 7.64894 -10.0112 4.74408 -6549 6 44.2058 6.2999 1.04709 5.21291 8.10008 11.2107 -6550 4 44.5368 6.97198 1.69742 -2.24215 -10.2401 -12.34 -6551 4 44.9393 6.09517 0.464894 1.54959 1.89788 1.1267 -6552 6 42.1369 38.61 31.1886 17.67 -9.24899 26.4806 -6553 4 41.7623 38.8803 30.3687 -14.3725 6.55505 -24.001 -6554 4 41.498 38.8614 31.8609 -3.32676 4.75778 -0.202389 -6555 6 43.7164 12.7972 9.05712 5.81528 3.72875 -30.711 -6556 4 43.3247 13.6946 8.89573 9.87346 -21.9812 3.16194 -6557 4 44.14 12.4709 8.19462 -12.6006 16.8915 32.7492 -6558 6 13.3844 0.443398 6.51083 -17.4423 24 5.83044 -6559 4 13.1471 1.18968 7.12521 11.9969 -17.0568 -16.1514 -6560 4 13.404 0.824606 5.60344 -0.330864 -2.32474 10.3957 -6561 6 16.1322 13.2809 10.2756 -7.67495 0.483234 -7.74316 -6562 4 16.9315 12.7781 10.4995 -2.28882 -8.98658 -2.43525 -6563 4 15.4389 12.669 9.92885 16.2568 3.72445 6.60733 -6564 6 1.59909 8.47465 4.69565 -12.106 -24.0688 17.9122 -6565 4 1.97809 9.06493 4.05503 13.7499 12.9224 -12.6029 -6566 4 2.17818 8.51684 5.47441 1.43398 4.73372 -5.14276 -6567 6 37.2847 1.71984 10.5234 11.0189 -27.5723 -13.4042 -6568 4 37.2468 2.67416 10.4778 -4.00861 9.27523 10.0347 -6569 4 36.8996 1.35439 11.335 -2.27729 16.2243 3.90618 -6570 6 53.8329 9.87891 17.6846 -38.3798 -30.924 7.14602 -6571 4 54.5301 10.0186 17.0634 18.0368 1.02749 -18.7159 -6572 4 53.3473 9.06138 17.3773 12.8854 20.2391 7.24153 -6573 6 45.4804 30.6107 15.8042 -8.04753 0.598448 7.23065 -6574 4 44.8245 31.2304 16.205 12.7241 -16.0174 -7.51778 -6575 4 45.2045 29.6903 15.9459 -0.384376 11.4708 0.631615 -6576 6 39.9212 16.643 33.8508 -27.7636 -7.17353 -19.4615 -6577 4 39.1766 17.1755 33.458 21.1378 -12.4278 10.7513 -6578 4 39.8244 15.7487 33.4296 5.23768 21.8708 14.061 -6579 6 32.8655 24.7639 27.9361 20.284 59.6053 -7.49862 -6580 4 33.6165 25.1458 28.4374 -8.60268 -19.6727 -0.650124 -6581 4 32.6313 25.5876 27.4183 -1.69816 -34.155 10.7383 -6582 6 7.87466 31.6143 24.1101 1.9117 20.6925 26.3443 -6583 4 7.66972 30.8573 24.7192 5.27436 26.873 -8.7819 -6584 4 7.9908 32.4716 24.6533 -12.57 -44.6195 -20.0842 -6585 6 43.5378 41.3358 15.8218 9.28004 -2.58796 -1.50951 -6586 4 43.1443 0.2957 15.6997 -2.19094 2.48586 -2.7957 -6587 4 44.4004 41.3722 15.3768 -7.99823 -0.449815 2.36698 -6588 6 20.0371 29.5453 33.205 3.08504 -20.5033 -11.6211 -6589 4 20.9096 29.2965 33.5637 -2.90058 10.2459 9.35691 -6590 4 19.6251 30.2513 33.706 8.84517 7.80605 8.87396 -6591 6 43.4117 21.4438 18.6347 -11.1342 -15.0059 14.8538 -6592 4 43.0276 21.2687 19.5098 8.56326 4.46648 -0.801958 -6593 4 42.8532 20.9111 18.0542 1.01153 2.95656 -9.2223 -6594 6 3.44653 19.1197 18.4217 23.6769 1.99723 9.81042 -6595 4 3.20802 20.045 18.3207 -2.32682 2.96104 -2.33529 -6596 4 2.63398 18.6303 18.3598 -12.7596 -8.76931 -2.32568 -6597 6 41.6678 38.1102 16.3244 12.531 -42.2252 -39.0953 -6598 4 41.9368 37.3879 15.641 -15.3799 38.9729 30.6603 -6599 4 42.3331 38.0554 17.0146 -0.0757724 1.18921 2.99625 -6600 6 7.55561 36.3978 10.4983 -3.44092 15.1931 -1.45671 -6601 4 6.72339 36.2337 10.0108 12.3142 -8.52859 4.51616 -6602 4 7.946 35.5335 10.7116 -10.6452 2.04557 -4.50299 -6603 6 36.2515 19.1074 34.8142 -43.7142 -17.0801 -27.3746 -6604 4 35.3817 19.3303 34.3863 23.1726 -6.06315 12.306 -6605 4 36.4633 19.8781 35.3097 10.3 22.3537 14.1292 -6606 6 53.5678 24.9372 12.6442 30.4342 18.5181 -32.2976 -6607 4 53.8348 25.8921 12.6266 -11.9077 -21.6197 10.5864 -6608 4 54.0165 24.5977 11.8224 -16.4724 -4.37861 26.9125 -6609 6 31.6766 10.443 21.0806 4.21881 -9.06253 -2.47208 -6610 4 31.4001 9.76622 21.7243 -7.70504 9.2495 -8.08332 -6611 4 30.9288 10.6617 20.4921 1.78432 -8.02731 8.28605 -6612 6 18.1094 28.7798 17.1891 14.7524 22.0605 -19.6834 -6613 4 19.0758 28.769 16.9872 -20.2742 -2.10771 9.28657 -6614 4 17.7731 29.5847 16.7123 5.43167 -23.0331 15.3038 -6615 6 21.675 18.2354 36.8765 16.12 -15.5286 8.52342 -6616 4 22.5529 17.9072 36.565 -22.4082 10.693 4.11156 -6617 4 21.5572 17.762 37.7329 -6.04816 8.67317 -10.9669 -6618 6 25.0658 19.0188 34.2159 -51.8076 2.97265 19.7815 -6619 4 24.747 18.4039 34.9114 5.38902 10.2451 -10.362 -6620 4 25.8774 18.6629 33.96 52.7001 -22.9877 -15.275 -6621 6 15.5692 13.0234 5.56242 -6.58245 2.44228 -13.4315 -6622 4 15.9945 13.4237 6.33643 -0.981395 -11.5063 2.18089 -6623 4 15.4281 12.0558 5.58603 5.20341 13.6823 8.40676 -6624 6 54.4716 41.6235 14.8012 14.2089 2.8312 2.80672 -6625 4 54.7869 41.5367 15.7234 -10.706 -4.16636 -8.71187 -6626 4 53.6678 41.1066 14.6963 -6.31993 -3.99892 7.53898 -6627 6 1.6781 26.4654 31.3743 5.67012 -21.4195 51.4057 -6628 4 2.55869 26.331 31.7713 -6.41431 -1.4007 -7.54986 -6629 4 1.81482 26.7235 30.4972 11.6805 15.9936 -52.9786 -6630 6 32.3382 37.285 29.6856 -26.7217 17.5069 7.43983 -6631 4 31.5807 37.8924 29.918 20.5429 -15.6126 -5.39856 -6632 4 33.128 37.6701 30.0913 2.74033 -1.11204 0.131524 -6633 6 52.7155 21.0369 22.8986 -26.6856 13.1044 -7.83906 -6634 4 51.927 21.5218 22.5308 17.9584 -10.8856 16.9396 -6635 4 53.1096 20.6236 22.131 10.0871 -9.76004 -3.40095 -6636 6 32.7546 28.5936 40.5151 -16.005 5.57574 20.6704 -6637 4 31.9696 29.0914 40.2712 1.08408 5.35728 -15.103 -6638 4 32.4826 28.2925 41.3957 13.2257 -7.23298 -6.66392 -6639 6 23.6064 32.0719 16.3529 6.2601 0.887785 0.577407 -6640 4 24.375 31.9361 16.9584 -22.6405 4.1158 -3.2487 -6641 4 22.7879 32.3052 16.8361 12.3926 -5.56708 -0.502672 -6642 6 37.5201 9.16809 29.9792 -2.73778 -7.47015 7.66604 -6643 4 36.7801 8.78215 30.4957 3.311 11.363 -11.2805 -6644 4 37.2059 9.98527 29.541 -5.1069 -9.85197 8.55889 -6645 6 2.27705 24.391 14.5477 -18.8311 -23.8216 -15.5117 -6646 4 1.75426 24.0938 15.3142 10.0576 11.8704 2.19803 -6647 4 1.95568 23.7778 13.8474 11.5886 17.7779 11.9828 -6648 6 27.3753 28.7961 24.7726 7.21008 -25.2057 -20.8265 -6649 4 27.1644 28.4274 25.6317 -2.92196 -0.0765173 10.3399 -6650 4 27.4291 28.0161 24.1505 1.02404 24.316 14.9 -6651 6 16.7879 2.56531 14.3086 11.9129 14.2285 -1.69346 -6652 4 17.7185 2.38196 14.3175 13.0278 5.32386 8.84309 -6653 4 16.4775 1.81817 13.8231 -22.7045 -15.6449 -12.1127 -6654 6 21.8022 39.8027 36.8001 40.4582 11.674 1.33338 -6655 4 22.755 39.5599 36.9347 -17 12.4394 -0.288792 -6656 4 21.461 38.9709 36.5396 -21.7153 -28.8447 -11.0269 -6657 6 14.0716 6.47232 41.542 21.0202 -14.2424 -6.97231 -6658 4 14.9696 6.10406 41.5939 -1.81915 -4.72532 -7.76656 -6659 4 14.0403 6.99701 0.421866 -13.8031 9.98176 13.4178 -6660 6 14.5555 16.5106 9.31543 20.3876 4.44524 4.12907 -6661 4 15.4025 16.5964 9.78828 0.864554 -6.42184 -12.9633 -6662 4 13.9847 17.046 9.86181 -12.8914 3.93145 3.80898 -6663 6 8.66171 23.4817 30.5575 -0.244333 -0.896371 32.8135 -6664 4 9.54353 23.6001 30.2398 18.7576 4.73722 -27.2602 -6665 4 8.85707 23.3999 31.5064 -16.6456 -3.41855 -0.290363 -6666 6 37.6497 2.07069 20.0046 29.2824 -26.1096 14.9164 -6667 4 37.0584 2.2163 19.2662 -13.6051 13.4744 -1.64318 -6668 4 37.4656 2.68422 20.7276 -9.488 6.31449 -9.7769 -6669 6 42.7264 7.54802 8.0174 22.2735 -23.3375 63.966 -6670 4 43.1898 7.96838 7.30926 14.9789 10.8108 -11.9713 -6671 4 43.3711 7.43923 8.8454 -34.4126 10.1207 -51.4479 -6672 6 38.5672 29.6578 6.85692 25.3422 5.29964 1.58487 -6673 4 38.5311 29.2984 7.75245 -9.71234 0.328663 -2.10015 -6674 4 37.7248 29.5682 6.41889 -15.2832 -4.18317 0.54199 -6675 6 42.5348 15.7114 39.7967 1.15785 13.3588 -25.5786 -6676 4 42.7129 16.6429 39.5831 1.88136 -1.51067 11.9166 -6677 4 42.2359 15.3735 38.9271 3.70013 -4.77916 17.2749 -6678 6 19.8546 7.43685 22.0566 -22.5975 2.81071 25.7956 -6679 4 19.2803 8.13273 21.6746 8.521 -7.13733 1.21439 -6680 4 19.4015 7.21173 22.9242 12.7412 8.86068 -31.9054 -6681 6 27.421 3.23371 12.5304 27.0524 21.0752 -24.489 -6682 4 28.3367 3.35644 12.1327 -27.9555 -7.8832 14.1518 -6683 4 27.3543 2.31638 12.8154 4.42645 -1.52034 -0.990676 -6684 6 34.4011 6.50186 34.3664 -16.3424 -2.90191 9.94761 -6685 4 33.6712 7.15225 34.4215 6.78416 -7.62851 1.00734 -6686 4 34.1394 5.7575 34.9538 2.66911 12.7001 -5.69623 -6687 6 9.88701 27.9536 39.7574 38.1218 -1.21446 9.36845 -6688 4 10.8313 27.9815 40.1009 -35.4969 -5.93471 -11.3457 -6689 4 9.7403 28.8357 39.397 -3.9481 4.17466 -3.11552 -6690 6 50.5681 22.1235 6.40489 -3.33101 1.51672 6.50125 -6691 4 51.5163 22.3536 6.46403 -14.0562 3.33212 10.0382 -6692 4 50.0608 22.5915 7.10741 15.6039 -2.37345 -9.267 -6693 6 47.1098 11.477 30.0359 32.4056 2.61276 18.961 -6694 4 47.3696 10.9259 30.8115 -10.3246 7.95021 -16.9085 -6695 4 46.3045 11.1726 29.6407 -20.48 -14.5539 -1.24473 -6696 6 25.9367 28.4654 9.80931 -8.38409 -27.2904 31.5361 -6697 4 26.8395 28.2564 10.1264 -14.1867 1.81997 -4.27567 -6698 4 25.3175 27.9176 10.3882 19.4096 21.4407 -17.1039 -6699 6 35.4417 36.6052 19.4431 3.65383 9.51374 12.5698 -6700 4 35.4442 36.5892 20.4356 4.35023 4.13201 -20.4161 -6701 4 36.0823 37.2978 19.1702 -7.18083 -5.57131 7.61291 -6702 6 39.0947 17.861 12.3005 -1.37104 18.7141 6.38745 -6703 4 39.0516 18.8013 12.5757 6.4741 -5.57949 -8.41576 -6704 4 38.3925 17.481 12.8252 -9.64523 -10.3587 5.73293 -6705 6 2.67895 27.1328 2.39169 -0.469231 -1.96621 -7.87892 -6706 4 2.01695 27.5866 1.84113 6.06579 -3.44887 4.00529 -6707 4 2.54603 27.3828 3.31988 1.36543 -1.57126 -4.01383 -6708 6 12.3125 32.2183 21.5204 7.73608 31.3279 -34.5621 -6709 4 12.8754 32.1648 22.302 -15.5368 -9.13091 6.69049 -6710 4 11.4514 31.7997 21.5885 -0.151568 -8.94455 23.3893 -6711 6 32.8824 32.3641 8.46179 -18.8611 4.30442 3.1153 -6712 4 33.4241 32.9657 8.96292 17.2175 7.79223 5.74753 -6713 4 32.0088 32.7748 8.50666 0.635289 -6.40729 -7.5616 -6714 6 12.649 6.44414 31.9754 -2.83404 4.50046 10.0363 -6715 4 13.204 6.32185 31.2101 8.19857 -2.9014 -11.0209 -6716 4 11.7563 6.235 31.704 -2.09981 -3.08597 -3.85403 -6717 6 41.3663 27.7408 14.044 -7.1512 -14.0341 -18.9391 -6718 4 41.8178 27.3798 13.2339 -12.2472 13.3456 19.5442 -6719 4 40.4043 27.5413 13.9741 19.5004 0.843126 1.31278 -6720 6 6.61204 16.505 25.4358 4.38086 10.1107 -4.22872 -6721 4 7.40634 15.95 25.3995 -3.52048 -0.326181 -5.74655 -6722 4 5.93615 16.0015 24.9584 5.4209 -2.01242 3.85811 -6723 6 21.7595 39.2992 13.3504 -47.5104 6.20728 42.9111 -6724 4 22.3466 39.2605 12.6295 26.4998 6.28224 -34.1528 -6725 4 21.7095 40.2078 13.7281 10.6984 -16.5323 -14.9329 -6726 6 34.8487 6.01484 6.95222 -29.6963 0.326386 -14.1862 -6727 4 33.862 5.88861 6.88689 25.1099 2.0969 11.0318 -6728 4 35.0754 6.24807 6.0365 6.49139 -1.48305 5.74594 -6729 6 33.0274 30.4243 33.1708 -20.2868 -13.6057 -33.0226 -6730 4 32.107 30.5622 32.8069 24.6222 -1.48625 15.7647 -6731 4 33.1252 31.0225 33.8918 -2.19017 18.1524 16.6028 -6732 6 15.459 32.4153 12.1907 25.026 -14.7999 12.6103 -6733 4 16.3707 32.0454 12.2858 -22.5133 7.43237 -2.39957 -6734 4 15.4871 32.8857 11.3664 4.63911 10.1509 -16.175 -6735 6 12.6896 26.6018 21.3639 -15.0944 -25.6853 -2.70918 -6736 4 11.948 26.0906 21.6799 0.937138 -29.673 -19.3981 -6737 4 12.542 27.2759 21.9777 19.0907 58.813 21.5342 -6738 6 47.0229 36.3064 29.9951 -7.32095 -4.41829 24.4392 -6739 4 47.4263 37.0889 30.4354 -10.9743 -13.05 -1.23566 -6740 4 46.4286 35.8162 30.6445 23.161 23.2616 -16.2608 -6741 6 0.29284 12.714 23.4069 -35.5625 7.7859 6.41586 -6742 4 0.591011 11.8915 23 -3.04289 0.952694 -0.179009 -6743 4 54.2726 12.6526 23.4069 36.7156 0.482893 -0.227565 -6744 6 54.1717 18.9252 21.5683 -50.0663 20.0699 0.290361 -6745 4 -0.00468748 18.6783 21.9698 30.2345 -16.5238 -1.58257 -6746 4 54.0846 18.73 20.626 15.626 -5.42297 0.74208 -6747 6 25.7258 24.2992 23.7444 19.803 -45.4072 -0.235584 -6748 4 25.1532 23.5493 23.4006 14.0979 28.9064 13.4272 -6749 4 26.557 23.8171 24.0636 -29.432 23.3848 -10.2309 -6750 6 11.8983 29.0288 26.8736 6.09277 -0.515715 3.71925 -6751 4 12.595 29.6797 27.0784 -3.35093 -5.68029 1.25498 -6752 4 11.9864 28.3255 27.5444 1.01315 10.8055 -7.75858 -6753 6 47.9911 35.8567 10.6981 8.08413 -4.02984 -21.6227 -6754 4 48.7745 35.7734 10.1229 -13.6418 -1.85084 -2.1863 -6755 4 48.3792 36.2903 11.4463 -1.30569 7.34959 21.4512 -6756 6 47.672 29.8438 36.9511 38.562 -32.0587 -16.7646 -6757 4 48.1514 29.311 36.2244 -26.8687 25.3781 26.6073 -6758 4 46.9232 30.3209 36.5927 -0.690739 -0.634879 -8.58348 -6759 6 7.33835 12.3416 10.615 -8.89583 -3.33234 -10.1121 -6760 4 7.22469 12.7824 9.73793 -1.24183 -8.23722 19.221 -6761 4 6.50851 12.5236 11.1156 17.4449 -0.896679 -14.5349 -6762 6 52.929 15.961 4.90278 -10.2898 -1.28264 -8.50781 -6763 4 53.0348 16.1145 3.95774 -1.18717 -0.815743 4.35872 -6764 4 53.806 16.0238 5.26597 15.814 -0.370642 9.21047 -6765 6 10.6777 16.9586 34.6035 -55.1347 -38.7426 5.67968 -6766 4 10.8984 16.7766 35.5088 23.7364 14.024 15.8473 -6767 4 9.8802 16.3472 34.5582 30.0556 27.9196 -18.3163 -6768 6 25.1377 31.056 36.0048 1.42921 -10.848 -28.6765 -6769 4 25.7744 31.7772 36.0714 -0.417948 1.95283 3.18329 -6770 4 25.3475 30.6244 35.1463 -8.66047 8.51414 18.9355 -6771 6 34.0941 21.8921 41.4705 -2.59948 8.49748 21.8065 -6772 4 33.8376 21.0023 41.2487 -0.891159 -17.6747 -3.00217 -6773 4 34.5263 22.2081 40.6953 10.3371 11.5397 -24.1167 -6774 6 15.7674 30.0637 1.25444 19.4532 4.17941 -23.0135 -6775 4 15.204 30.4318 1.91689 -16.4157 4.77211 21.8875 -6776 4 16.1981 30.8773 0.915598 -5.77798 -19.2538 1.08217 -6777 6 29.5177 27.8662 16.6069 -21.9867 -20.8772 26.8051 -6778 4 29.4575 26.8938 16.8925 2.72258 42.9501 -5.19299 -6779 4 28.8337 28.3532 17.1557 16.905 -14.8206 -13.8895 -6780 6 39.6418 9.77683 0.55649 6.97543 15.8838 23.3716 -6781 4 40.1108 10.6055 0.868863 -11.4024 -23.0197 -7.66085 -6782 4 39.4946 9.23542 1.36828 3.21978 8.9832 -14.2415 -6783 6 1.52158 31.8692 16.4183 -13.8984 7.04184 27.8471 -6784 4 2.05742 32.2974 15.7673 16.5414 8.9668 -16.2997 -6785 4 1.54493 30.9444 16.2035 3.31157 -20.7597 -8.56027 -6786 6 8.73651 39.8559 25.0424 -4.76165 -15.5453 0.0774869 -6787 4 8.05377 39.648 25.6948 0.177415 -5.7342 -2.33302 -6788 4 8.86744 40.7877 25.1714 9.39418 20.2019 -3.50565 -6789 6 42.3206 10.2864 9.76098 2.95973 19.1246 -1.63703 -6790 4 42.201 10.133 10.7061 4.21692 -0.996774 -0.328573 -6791 4 42.7677 11.1578 9.6855 -5.09192 -13.1904 -0.0451331 -6792 6 13.2407 7.61713 1.96996 -7.39862 -1.41628 8.88927 -6793 4 13.9913 7.91748 2.51852 -7.45732 -2.50241 0.703823 -6794 4 12.5579 7.21318 2.54911 15.3337 9.06064 -6.21655 -6795 6 18.7418 40.0591 14.2229 14.6643 6.60726 6.61579 -6796 4 19.3344 39.8885 14.9901 -13.3575 3.17545 -12.3588 -6797 4 17.9636 39.4956 14.2872 3.6042 -5.87931 7.54738 -6798 6 20.1073 14.0529 38.5598 27.8117 -61.2518 1.76132 -6799 4 20.1641 13.6472 37.6602 -4.05869 13.902 17.7453 -6800 4 19.784 14.907 38.4293 -21.3136 56.4597 -12.4562 -6801 6 22.6529 28.8869 34.0687 6.58134 -12.6264 20.4136 -6802 4 23.051 28.2341 33.486 -0.980474 2.102 -8.59088 -6803 4 22.967 28.5961 34.9503 -6.50134 7.38476 -6.63172 -6804 6 22.6736 4.71248 5.24178 -0.00794307 -2.96021 -16.86 -6805 4 22.1728 3.90748 5.48978 2.26378 16.1145 9.27739 -6806 4 22.7088 5.35566 5.95806 -4.05577 -5.29394 11.9552 -6807 6 23.6374 34.0001 38.3917 50.061 26.1352 -20.3518 -6808 4 22.8137 33.6238 38.6177 -41.7704 -11.5062 -0.965889 -6809 4 23.6153 34.3835 37.4812 -9.56218 -11.3792 16.4738 -6810 6 48.3816 21.3644 17.2759 -0.964958 21.4078 15.1884 -6811 4 48.1603 22.346 17.2347 5.31328 -30.3781 -7.15015 -6812 4 48.2799 20.9337 16.4123 -2.86285 15.3202 1.32987 -6813 6 11.5786 11.0066 8.63803 -22.8025 30.9503 41.2381 -6814 4 11.6342 10.2487 9.24135 6.24209 -4.12245 -6.65597 -6815 4 11.0653 11.6976 9.17674 20.0011 -23.9124 -25.5895 -6816 6 40.098 28.1667 33.502 25.4322 5.13826 0.328547 -6817 4 41.0532 28.3457 33.4282 -8.43417 -7.39989 8.78785 -6818 4 39.8078 28.5143 32.6608 -12.8477 1.2165 -2.93222 -6819 6 47.3852 25.6796 5.28879 12.5804 32.9376 -10.0311 -6820 4 46.4546 25.5561 5.13624 -16.8804 -10.2001 -0.268496 -6821 4 47.5232 26.6241 5.03253 2.87445 -14.5067 3.75712 -6822 6 21.6604 35.221 23.9985 9.0652 15.9564 -12.6156 -6823 4 21.5339 34.4977 24.6161 5.50034 -7.33202 6.93593 -6824 4 22.5891 35.5406 24.0132 -10.9025 -9.97729 6.37443 -6825 6 8.25067 41.5023 8.40693 4.57396 0.593767 -7.67714 -6826 4 8.14583 40.8128 7.73311 1.23406 2.32353 -0.157563 -6827 4 7.86929 41.1416 9.20784 -2.18245 3.41182 6.12515 -6828 6 16.4756 31.0916 22.2208 -15.8048 -5.76047 -3.57767 -6829 4 16.9823 30.8797 21.4186 0.224111 -1.11381 3.57708 -6830 4 17.0871 31.1495 22.9566 10.3822 -1.94934 1.40451 -6831 6 54.7052 0.441622 28.3216 30.4392 7.42547 7.16367 -6832 4 0.670225 0.280878 28.2941 -2.60978 -25.0778 -11.1355 -6833 4 54.7831 1.35385 28.5964 -22.0828 12.0381 3.63841 -6834 6 48.4365 15.3814 4.18175 16.1137 -59.8395 -8.29881 -6835 4 49.2486 15.0627 4.66696 -19.7577 20.5705 -9.22457 -6836 4 48.202 14.5739 3.61717 1.65501 39.0327 16.4105 -6837 6 34.3447 6.98096 40.4233 28.1894 -26.1309 -0.966046 -6838 4 33.5941 7.1072 39.8443 -1.28272 -2.58724 -7.46065 -6839 4 35.0352 6.39393 39.9745 -30.768 20.5054 8.50532 -6840 6 41.3452 3.36617 16.9999 -11.8967 -16.9054 2.63506 -6841 4 41.0249 2.72492 17.6694 2.1854 6.18106 -7.89089 -6842 4 41.9449 3.92974 17.49 7.08552 9.22633 4.28017 -6843 6 48.4488 20.6937 14.5344 36.1561 -40.2628 27.2518 -6844 4 47.9962 21.3635 14.0898 -25.7182 45.1623 -29.349 -6845 4 49.3977 20.8911 14.4834 -7.22111 0.680744 -3.09477 -6846 6 52.5006 28.1422 37.1181 -0.438891 10.9489 1.55023 -6847 4 53.461 28.2559 37.0441 -2.53591 -5.73983 -7.32344 -6848 4 52.1579 27.9957 36.2188 6.05301 2.29627 6.02383 -6849 6 53.8778 18.5596 18.7916 -16.4261 -54.6782 2.06415 -6850 4 54.6924 18.1462 18.492 5.89253 -2.608 -0.931268 -6851 4 54.0684 19.4623 18.7843 11.279 55.5152 0.463912 -6852 6 40.9954 39.1455 28.7887 -28.6383 -4.85259 53.4888 -6853 4 41.3933 39.2419 27.9663 30.849 7.00679 -57.5311 -6854 4 40.0484 39.2316 28.6375 -4.32997 -1.25138 -0.266272 -6855 6 38.2708 8.75593 24.2289 27.2886 -4.9888 -5.43324 -6856 4 39.2171 8.59021 23.9715 -26.3742 3.09491 7.04217 -6857 4 38.3303 9.34105 24.9905 -3.83131 2.71498 5.53525 -6858 6 2.99948 29.1469 9.63392 26.6909 -34.1608 2.5373 -6859 4 2.51216 28.7995 8.89273 -4.75194 -2.8028 -9.24178 -6860 4 2.58111 29.9575 9.82954 -15.8869 33.6035 13.3424 -6861 6 27.5773 29.2771 18.3181 4.27818 -11.5166 33.1226 -6862 4 26.7531 29.1546 17.8331 -9.3021 -0.872639 -4.78576 -6863 4 27.3558 28.9731 19.2647 9.0806 12.9475 -44.783 -6864 6 11.8527 21.1658 10.1208 3.44892 -32.1211 19.512 -6865 4 12.1978 22.0146 9.89711 8.39983 22.4635 -8.03232 -6866 4 12.4593 20.8304 10.8135 -12.0936 9.66798 -13.0295 -6867 6 16.8988 32.3014 0.299949 1.29982 1.68058 -0.586211 -6868 4 17.7043 32.7282 0.600499 13.9817 -1.747 3.00212 -6869 4 16.3216 33.0562 0.17902 -12.1561 7.80428 -5.7129 -6870 6 1.309 17.4831 22.5447 23.3848 -11.3219 -15.6007 -6871 4 1.13597 16.5744 22.1718 3.15619 19.2398 8.80125 -6872 4 2.27868 17.6899 22.4311 -25.7511 -7.40397 3.71946 -6873 6 41.5587 6.87311 29.3039 4.08196 29.5448 1.53382 -6874 4 41.6919 5.95311 29.5356 2.80206 -5.98386 3.69024 -6875 4 41.9106 7.40602 30.0483 -3.99043 -10.4039 -5.51054 -6876 6 10.5167 10.7886 13.8618 17.7458 -17.1897 13.2051 -6877 4 10.6632 11.2096 13.003 1.79898 0.261401 -4.84225 -6878 4 11.2159 10.1 14.0373 -16.1376 17.4326 -7.31573 -6879 6 39.8332 15.4952 40.8309 13.3581 4.75609 3.89566 -6880 4 39.9392 16.0809 40.0548 0.3292 -3.56753 7.15077 -6881 4 40.6564 15.5643 41.3732 -15.0531 5.58747 -11.8726 -6882 6 26.5094 19.6057 40.5003 9.17758 -2.41024 9.24949 -6883 4 27.4312 19.885 40.5187 -1.32295 2.31326 -8.74715 -6884 4 26.4504 19.08 41.3172 -10.7617 -0.025449 -2.36491 -6885 6 54.0331 8.19348 13.7645 20.1265 23.4755 -3.20859 -6886 4 54.5379 7.42769 14.0195 10.1236 -9.46733 3.3174 -6887 4 53.1635 7.89609 13.5919 -33.2862 -9.18344 -4.84573 -6888 6 15.685 25.3343 10.6639 3.77823 -5.01457 0.699023 -6889 4 15.2925 25.3549 9.7704 -6.94194 -0.507815 8.78718 -6890 4 14.9859 25.2981 11.3464 3.26271 -0.250944 -15.837 -6891 6 18.6044 3.42728 21.9359 54.0117 -4.17358 13.1129 -6892 4 19.6007 3.50499 22.1915 -55.8621 -1.2706 -18.0159 -6893 4 18.5414 3.70523 21.0018 -0.6471 0.781857 10.4283 -6894 6 50.8906 20.6382 18.514 19.322 19.8933 14.7131 -6895 4 50.0771 21.0514 18.1693 2.40506 3.30677 2.13188 -6896 4 51.4314 21.2881 19.0676 -26.3068 -18.4046 -20.3942 -6897 6 53.3692 20.9044 31.2861 -2.87581 -0.0590227 -4.61483 -6898 4 53.3163 20.8663 32.2507 -1.10677 -1.05899 -2.14121 -6899 4 52.4655 20.8115 30.924 8.48272 0.484508 7.85381 -6900 6 52.8175 27.637 28.9992 -34.1073 -16.3293 -5.23745 -6901 4 52.1753 27.4604 29.7292 18.9476 13.4611 -8.14668 -6902 4 53.5412 28.184 29.256 17.7352 16.912 19.7012 -6903 6 33.3098 15.691 11.3293 10.3241 5.44869 29.2776 -6904 4 33.5439 15.9761 12.2647 -8.49351 -12.0766 -30.078 -6905 4 32.4682 16.1118 11.1139 -1.38634 1.49203 3.14806 -6906 6 20.3823 26.792 27.4754 10.6616 14.7237 17.2289 -6907 4 19.6846 27.4135 27.2507 -4.69437 -0.849554 -6.03625 -6908 4 20.895 27.2908 28.1563 -10.3656 -18.3754 -15.2612 -6909 6 8.54404 2.05454 14.1651 1.1449 13.7122 2.29602 -6910 4 8.12946 1.19872 14.2191 -6.02545 -13.9865 0.607463 -6911 4 8.06484 2.58201 14.8308 4.74922 -3.38849 -5.44478 -6912 6 40.1105 7.56396 40.6794 -0.469697 6.72942 -1.63666 -6913 4 39.7195 8.28533 41.2425 20.0171 -18.0739 -7.27063 -6914 4 40.8018 7.03949 41.1472 -13.6242 13.5344 3.71207 -6915 6 6.897 6.83213 10.7811 7.71606 15.0782 -3.77655 -6916 4 7.19774 7.75246 10.6132 -6.74961 -17.2243 4.00207 -6917 4 7.00156 6.6927 11.7358 -2.06706 0.697676 -4.80225 -6918 6 31.2469 6.57665 20.133 15.2512 -44.8317 5.05575 -6919 4 30.6435 5.99888 20.634 -3.65198 3.16249 1.16613 -6920 4 30.7682 7.35458 19.9689 -22.0921 35.6742 -6.0398 -6921 6 54.5384 21.0446 27.3066 23.2273 -48.3206 40.5729 -6922 4 0.0992734 20.2122 27.4067 -21.2046 24.987 7.15799 -6923 4 54.6588 21.2398 26.4073 -2.82622 20.9035 -45.5707 -6924 6 4.74298 23.1434 16.2203 -30.2995 19.4891 -12.6787 -6925 4 4.36556 24.0555 16.215 7.46998 -18.526 0.357752 -6926 4 5.49124 23.2367 16.7883 23.1348 -5.45784 14.6166 -6927 6 25.5466 11.0338 14.8277 10.3359 0.700294 4.3384 -6928 4 26.1246 10.3443 15.2243 -8.70528 11.4294 -11.7317 -6929 4 25.9183 11.8873 15.0941 -0.865353 -5.34287 -3.41216 -6930 6 41.1962 41.784 29.9422 -30.017 -5.50367 -10.8152 -6931 4 40.9141 40.905 29.5845 10.5201 22.1914 8.67773 -6932 4 40.3904 0.453034 29.9085 19.4524 -11.6054 2.3136 -6933 6 52.2783 15.2862 41.6211 7.07203 -4.19206 -10.8941 -6934 4 51.9431 15.9476 0.307056 -1.67854 11.1856 8.97788 -6935 4 51.5699 14.6487 41.5543 -8.05659 -11.9472 -4.98288 -6936 6 37.758 21.7866 37.8526 10.4754 12.291 4.40187 -6937 4 37.8833 20.8525 37.7239 2.64231 -18.5298 -3.43162 -6938 4 38.1062 21.9123 38.7409 -0.189838 4.59809 2.45253 -6939 6 23.846 9.72877 27.5599 -20.0483 -53.0743 -18.3837 -6940 4 23.7508 8.9538 26.878 9.78252 41.145 35.6193 -6941 4 23.2758 9.50619 28.3397 9.82275 7.24107 -18.911 -6942 6 43.0179 28.0371 32.8168 -8.27592 12.0689 -0.875134 -6943 4 42.8326 27.1827 33.2413 14.9994 1.75302 -2.99965 -6944 4 43.9358 28.1723 32.5349 -8.32605 -13.2452 6.20231 -6945 6 34.1493 21.223 11.895 -6.4617 -26.4803 6.62596 -6946 4 33.7114 20.3967 12.2433 5.74917 23.5867 -12.2191 -6947 4 33.6625 21.5015 11.0997 -1.34318 -2.64619 5.02085 -6948 6 10.5048 31.8203 10.0934 3.12763 27.8567 -5.97475 -6949 4 10.8893 32.6663 10.3856 -2.25958 -16.5293 2.97323 -6950 4 10.042 32.0955 9.27903 1.62317 -10.8132 6.61598 -6951 6 35.8582 37.1311 22.1219 17.442 6.8165 -15.3109 -6952 4 36.7754 37.4644 22.0121 -13.2022 -8.29883 -6.66499 -6953 4 35.6795 37.2674 23.0383 -11.5038 0.0185045 25.2366 -6954 6 27.2889 4.59659 27.4585 -59.4895 -12.2555 32.2126 -6955 4 27.8503 4.63259 28.2407 7.94553 1.46958 -1.61102 -6956 4 26.3513 4.38137 27.8533 49.6255 8.2673 -26.6042 -6957 6 39.0071 22.2889 10.6559 -18.7539 6.55471 8.53947 -6958 4 39.6145 22.0219 9.97399 11.0637 -4.63202 -10.5583 -6959 4 38.132 22.2267 10.2407 1.98377 -6.13574 3.6668 -6960 6 30.7475 39.195 10.9378 13.4076 -25.4475 -2.13886 -6961 4 31.7135 39.1987 10.9202 1.84768 25.2682 1.10777 -6962 4 30.6542 38.2342 10.8274 -15.9936 9.0572 -1.5893 -6963 6 44.6038 26.9469 2.19596 -3.02312 -2.7981 0.496435 -6964 4 44.789 26.0668 2.58199 4.34993 15.1048 -14.5643 -6965 4 45.3477 27.2287 1.63769 1.54159 -5.20589 8.29494 -6966 6 23.7761 14.5574 26.4892 -1.60295 28.5342 -20.4107 -6967 4 23.6176 15.1119 25.659 4.49284 -25.3407 28.839 -6968 4 23.2395 13.7622 26.4238 -2.18231 -2.53609 -2.40557 -6969 6 38.3444 13.3746 39.6516 36.4054 -1.80378 3.51049 -6970 4 39.1202 13.8805 40.0461 -33.1028 -11.4882 -12.1373 -6971 4 37.5326 13.855 39.8351 -2.35218 5.60767 6.28087 -6972 6 17.8972 17.2344 29.4073 9.50877 -9.96512 10.1834 -6973 4 17.6974 16.8197 28.5593 -3.90288 0.722299 -3.3346 -6974 4 17.259 17.9348 29.5179 -13.7448 8.39178 0.729907 -6975 6 17.4263 29.84 9.91085 4.63967 13.4244 18.4952 -6976 4 16.5241 29.7155 9.63978 -6.68442 -7.79832 -10.641 -6977 4 18.0121 29.6473 9.18714 6.17675 -5.88453 -9.84082 -6978 6 35.6257 6.05657 19.614 -2.53427 -7.67526 1.74575 -6979 4 35.1442 5.56448 18.9178 7.07991 15.7277 0.668344 -6980 4 35.8526 6.94177 19.2847 -2.44106 -6.98166 -5.33042 -6981 6 18.6731 22.2952 17.5195 -8.35574 4.99894 -0.254983 -6982 4 17.7298 22.4259 17.6349 -7.1371 0.699885 10.6378 -6983 4 18.7532 22.3981 16.578 9.97204 2.32932 -16.3296 -6984 6 20.0126 3.82895 32.2846 -5.38506 7.6032 10.998 -6985 4 19.7316 4.05659 31.3951 3.95105 0.959407 -6.40709 -6986 4 20.9087 3.45699 32.2166 -3.62371 1.18893 -2.87546 -6987 6 5.48106 6.97474 8.11911 -13.3431 -28.5569 -4.23146 -6988 4 5.76723 7.87539 8.05126 9.5873 19.9723 5.64469 -6989 4 5.84003 6.56862 8.91875 4.365 4.20298 7.41399 -6990 6 44.2055 20.527 25.594 -36.5422 -32.7496 -22.1294 -6991 4 44.4952 21.1964 26.2048 27.2712 12.1663 0.509182 -6992 4 44.8136 20.1687 24.9192 13.264 16.717 13.5958 -6993 6 43.9676 36.9898 17.8707 9.43563 13.9581 11.3899 -6994 4 44.6425 37.4866 17.3506 -13.9886 -14.2814 1.04264 -6995 4 43.5166 36.316 17.3518 1.57776 -4.71986 -9.07493 -6996 6 34.624 10.1249 16.2553 -3.80507 -0.870494 -23.8528 -6997 4 34.4029 10.0232 15.2766 7.60873 7.05542 33.3523 -6998 4 34.6485 11.0843 16.4397 0.136369 -4.79707 -6.11079 -6999 6 23.6588 3.43472 1.31587 2.0947 2.20184 -10.1691 -7000 4 23.5283 2.45383 1.23665 3.68597 29.2686 -10.0862 -7001 4 23.7829 3.95594 0.465507 -5.48879 -27.0668 21.3429 -7002 6 33.408 38.9514 5.0951 12.9752 29.4037 8.61745 -7003 4 33.0296 38.079 4.95882 -18.4714 -2.71742 3.9597 -7004 4 32.7559 39.6696 5.33685 4.56028 -29.4715 -9.24259 -7005 6 22.5612 32.5054 35.7914 -7.59797 17.3543 -6.08959 -7006 4 23.434 32.1498 35.9581 8.59623 -0.183209 1.98348 -7007 4 22.6598 33.4814 35.6698 2.01652 -18.126 2.22848 -7008 6 32.4197 37.2669 13.8205 20.7322 22.1346 -9.91782 -7009 4 31.6112 36.8955 13.5272 -29.3682 -10.7083 -8.61391 -7010 4 32.7793 36.5983 14.3861 8.71878 -17.2052 10.8721 -7011 6 52.6061 12.7509 39.5955 -8.08982 -5.36768 -0.728302 -7012 4 53.2357 13.3696 39.2333 6.80499 9.05338 -6.44134 -7013 4 53.0752 12.2813 40.2869 4.34006 -2.9945 3.85342 -7014 6 28.8406 14.5639 1.22393 13.2702 13.2594 -7.07732 -7015 4 28.2547 13.832 1.29641 -8.98786 -23.9917 -3.18497 -7016 4 28.3081 15.2705 1.57856 0.691728 8.20301 3.76967 -7017 6 1.46371 32.4171 23.3808 -12.1734 -25.5645 13.9938 -7018 4 1.52421 31.5049 23.0145 7.51613 19.861 -1.66683 -7019 4 1.90409 33.05 22.8306 10.4998 5.06095 -20.3958 -7020 6 54.3326 23.3294 28.9734 2.61182 15.3833 -1.51239 -7021 4 54.2696 22.9227 29.8387 -0.130455 -4.55084 5.05008 -7022 4 54.4476 22.6226 28.3359 -0.0534198 -9.82677 -0.516761 -7023 6 14.3165 12.143 35.6759 -19.2415 -8.81627 -0.503167 -7024 4 14.3877 12.7977 36.3527 0.233596 18.6669 11.2481 -7025 4 15.2077 11.8775 35.5438 25.0768 -7.98239 -7.51161 -7026 6 18.9926 6.51479 41.2701 -28.9824 -29.6237 1.81046 -7027 4 18.266 5.84223 41.3522 13.7729 17.3268 -5.20094 -7028 4 19.3309 6.57432 0.258232 8.64619 7.1183 4.95474 -7029 6 5.3156 17.8978 20.3375 -21.1545 16.5991 3.60383 -7030 4 4.72623 18.3448 19.6879 4.29754 -5.05212 8.41069 -7031 4 4.82948 17.9368 21.1935 9.1049 1.98802 -15.8618 -7032 6 24.7216 34.9676 30.1666 -3.07326 -14.2394 -14.8574 -7033 4 24.8542 35.9126 30.1802 4.14387 12.0412 4.3338 -7034 4 24.7023 34.7085 29.2239 -0.0690866 8.67132 12.606 -7035 6 31.8759 4.61762 18.1838 16.2734 -6.94643 -1.61547 -7036 4 31.7767 5.32612 18.8146 -0.693712 9.66586 8.6442 -7037 4 30.9961 4.53608 17.8264 -12.7431 -2.99311 -6.3499 -7038 6 8.70679 17.4876 5.93376 -7.2594 15.0659 3.57914 -7039 4 7.94553 18.1226 5.84491 19.4684 -9.25267 2.2845 -7040 4 9.55198 17.9922 5.98984 -15.4384 -2.82622 -0.0668602 -7041 6 29.8338 10.9771 14.4736 2.85583 -20.8689 4.17621 -7042 4 29.3487 11.4359 13.7779 -2.35633 12.0716 2.99849 -7043 4 29.9333 11.5067 15.2792 -5.11986 9.15119 -1.36774 -7044 6 48.7176 10.2992 32.5766 37.752 -4.2965 -7.5649 -7045 4 48.6861 9.98692 33.5109 4.36425 8.41374 -15.5521 -7046 4 49.6689 10.1741 32.2115 -43.6207 3.75412 17.6406 -7047 6 8.33261 15.6868 37.8739 25.2856 -16.7599 -34.932 -7048 4 8.10095 16.0156 38.719 -17.2941 17.7495 29.2541 -7049 4 7.84865 16.1686 37.1872 -4.77393 6.83012 10.4818 -7050 6 50.4 3.07893 17.326 6.75193 2.54677 -10.5223 -7051 4 49.8476 3.08454 16.5614 0.0537611 0.514048 -24.7797 -7052 4 49.7563 3.22783 17.9993 -5.52918 6.4504 35.6689 -7053 6 14.6925 38.3995 10.8943 -10.4545 -11.2686 -1.07851 -7054 4 14.3539 38.6226 11.7634 0.533319 14.8424 10.3104 -7055 4 14.2274 37.5681 10.7419 5.82896 -0.087222 -8.72758 -7056 6 34.1157 6.37736 10.827 20.4112 17.5403 9.63945 -7057 4 34.1356 7.15575 10.2337 -4.79421 -13.4894 2.09643 -7058 4 34.9392 6.47467 11.3721 -17.4677 -2.57189 -8.67394 -7059 6 7.16428 37.5549 17.6272 35.8206 -6.94283 1.42456 -7060 4 8.17672 37.4379 17.5039 -45.4701 3.04153 9.54579 -7061 4 6.9329 37.0909 18.4673 4.48983 7.2965 -12.9876 -7062 6 51.5173 11.3068 16.7982 -29.6345 12.4732 -19.9425 -7063 4 52.2329 10.8476 17.1999 24.0623 -16.8016 7.00331 -7064 4 51.4947 11.1437 15.8343 5.46468 -1.37513 9.57578 -7065 6 15.6604 8.64432 3.1895 3.55656 -13.2601 -18.336 -7066 4 15.3831 9.26805 3.84437 -11.3932 20.6181 15.5674 -7067 4 16.2117 8.03967 3.68493 6.317 -8.49687 -0.892024 -7068 6 5.4241 21.4549 11.925 7.11554 10.6798 -7.02681 -7069 4 5.33432 22.3429 11.4717 -4.65036 -17.889 17.4658 -7070 4 4.77116 21.2815 12.6313 -0.367847 15.68 -7.67111 -7071 6 50.1893 24.0442 37.9781 -13.1484 0.855785 -17.0816 -7072 4 49.5179 24.1845 37.2801 8.13829 0.111989 16.6227 -7073 4 50.739 23.3224 37.6715 2.2014 -1.01472 3.1635 -7074 6 39.7382 11.2507 31.6977 23.6406 7.23187 -3.58891 -7075 4 40.4046 11.8538 31.2923 -18.8268 -10.2166 5.80002 -7076 4 38.8713 11.6238 31.5229 -1.54541 8.70996 -4.13134 -7077 6 26.6923 10.8294 20.5841 1.50171 17.3672 -0.163562 -7078 4 26.3063 11.3901 21.299 5.00814 -17.7696 -11.6362 -7079 4 26.5519 9.91114 20.8376 -1.99146 -0.979444 5.82041 -7080 6 12.5744 17.5779 18.1705 9.62673 -31.396 -11.9521 -7081 4 12.2909 16.663 17.987 19.11 1.74385 -8.92353 -7082 4 11.8345 17.8227 18.6757 -30.0259 29.7826 25.4081 -7083 6 47.7778 31.6094 17.3292 -7.10666 -17.038 -8.06235 -7084 4 48.347 31.2547 18.014 2.28217 1.30733 4.94459 -7085 4 47.3418 30.8212 16.9416 1.10301 17.3121 -1.07651 -7086 6 1.06524 3.39018 18.5298 -14.3894 10.3619 10.5476 -7087 4 1.40487 3.81402 19.3241 14.4239 4.64695 -0.395869 -7088 4 0.13491 3.28998 18.7837 -2.56119 -4.67364 -10.5163 -7089 6 26.5953 20.387 15.3121 4.86749 -24.5982 -5.101 -7090 4 27.0693 19.5476 15.0746 -6.18915 17.8108 6.48343 -7091 4 25.6882 20.059 15.4501 7.15985 4.40883 -1.86988 -7092 6 42.0068 3.03472 36.7639 -8.02624 -14.3838 3.82934 -7093 4 41.5138 2.21919 36.6422 -1.8797 -9.24856 -19.1073 -7094 4 41.9017 3.12445 37.6992 6.42334 14.3979 20.8626 -7095 6 39.3283 22.4329 33.1866 16.7976 22.9312 16.1168 -7096 4 39.617 22.6043 34.1233 -9.1007 -15.4059 -24.4851 -7097 4 39.2996 23.351 32.8579 -1.9326 -13.3537 -7.72798 -7098 6 18.5014 34.9723 11.9503 -40.872 8.93582 -22.0032 -7099 4 19.313 34.895 12.3871 37.9781 -3.12322 33.9295 -7100 4 17.8134 35.1232 12.6133 -0.0311416 1.40314 8.7121 -7101 6 22.862 14.1089 0.203393 17.2545 -2.37957 19.5806 -7102 4 23.1276 14.8054 41.5255 0.219481 9.03583 -13.3452 -7103 4 23.4003 14.3117 0.999915 -8.23864 -6.67581 -7.59618 -7104 6 30.9898 16.6325 33.7811 -26.24 4.82889 -18.7278 -7105 4 30.4991 16.9295 32.9906 -1.06726 -7.21679 15.5744 -7106 4 31.8724 16.8786 33.545 20.2345 1.84197 6.64809 -7107 6 28.4142 35.5086 5.55132 5.25795 11.5001 -0.86936 -7108 4 29.133 34.8901 5.6729 7.87573 -11.0207 0.32142 -7109 4 28.8444 36.3678 5.44284 -5.96253 -1.38672 0.306744 -7110 6 2.06178 31.4487 10.6522 7.7724 2.5252 5.43788 -7111 4 2.46787 32.1741 10.1582 1.48866 -1.05725 0.00513454 -7112 4 1.12423 31.5492 10.4902 -10.7705 -1.69396 -4.48797 -7113 6 5.96168 9.75465 21.3469 -3.89643 8.81348 -50.5901 -7114 4 6.28958 10.5041 20.7544 -9.04712 -29.7196 22.9081 -7115 4 5.37557 9.21645 20.7377 15.5825 17.9805 22.1648 -7116 6 24.7784 26.6095 2.66066 11.1746 -2.24162 5.28408 -7117 4 23.9956 26.7754 2.10108 -2.29597 -10.0774 9.56872 -7118 4 24.6953 25.8682 3.30791 -10.2989 11.7132 -14.8816 -7119 6 45.7373 4.24983 18.6143 27.3178 -0.763462 -4.2154 -7120 4 46.5067 4.85242 18.4954 -19.0177 -2.03966 3.70694 -7121 4 46.1538 3.38182 18.4484 -14.6954 3.88493 3.6473 -7122 6 4.46307 0.776675 15.9004 -0.0751459 19.7124 -7.24544 -7123 4 4.28648 41.7452 15.8506 7.90268 -11.6504 4.49907 -7124 4 5.34722 0.941656 16.2766 -7.84 -9.44871 -1.18019 -7125 6 2.43543 19.4835 25.3975 -8.02289 7.34849 22.5637 -7126 4 1.8039 19.0427 26.0095 9.34608 -2.48106 -16.7091 -7127 4 2.63666 18.9452 24.6346 -2.8512 -10.1259 -3.82486 -7128 6 40.5893 8.48301 5.11314 -1.35782 -12.8068 -2.32465 -7129 4 40.7524 9.27543 5.61119 -3.30667 17.7402 10.4879 -7130 4 41.4486 8.05286 5.16027 3.34022 -8.8045 -8.92488 -7131 6 49.3107 22.3512 41.5276 -10.6582 56.3201 6.76971 -7132 4 48.577 22.7852 41.0387 15.264 -8.60422 5.01334 -7133 4 49.2575 21.458 41.2835 -0.448838 -46.7272 -11.6484 -7134 6 0.358901 40.9209 20.5803 -19.8443 -5.20423 -21.0143 -7135 4 0.209912 39.9476 20.5616 0.00996972 10.506 -0.843682 -7136 4 54.6254 41.351 20.0384 15.1519 -13.0167 14.2251 -7137 6 34.868 15.3449 38.0159 -4.77394 11.9701 -21.6163 -7138 4 34.21 16.0699 37.905 14.1938 -11.5268 -7.28032 -7139 4 35.478 15.4115 37.2329 -18.0572 6.07255 16.3223 -7140 6 7.76403 26.0071 29.8556 5.34791 -0.957035 4.21351 -7141 4 8.62364 26.4528 30.0224 -8.82329 -12.5157 -0.945539 -7142 4 7.90301 25.0604 30.0866 1.23738 19.4493 -2.25897 -7143 6 40.714 22.798 20.4449 30.2403 28.6605 -20.1452 -7144 4 41.3584 23.4838 20.081 -22.4198 -29.1089 11.875 -7145 4 40.2102 23.3285 21.0558 -12.075 4.18803 12.4472 -7146 6 37.6868 25.6422 36.0641 6.66209 -5.59755 13.6904 -7147 4 38.2808 24.8923 36.0269 4.65063 -3.44496 7.57849 -7148 4 37.3429 25.6351 35.1859 -16.0941 8.70932 -25.1352 -7149 6 5.45062 23.9828 10.2587 5.16865 5.9624 5.01697 -7150 4 5.97911 23.8188 9.45867 -6.21725 4.51436 8.29683 -7151 4 5.82702 24.8173 10.6422 -10.2102 -24.7042 -13.9856 -7152 6 48.3972 21.0585 38.1887 36.079 14.8531 -15.9941 -7153 4 48.9083 20.6932 38.9203 -9.15007 -3.24726 4.47194 -7154 4 49.1186 21.3212 37.5505 -33.8036 -6.43701 14.9947 -7155 6 15.2894 25.0118 3.53737 -15.5341 -16.8072 10.9824 -7156 4 15.3523 24.0463 3.54635 7.80908 -0.218079 -10.1213 -7157 4 14.6524 25.152 4.25109 -0.971191 12.1275 -1.41446 -7158 6 46.3973 40.2818 20.0864 -5.10979 -28.8528 0.810189 -7159 4 46.7099 39.3289 20.1836 -4.69047 35.7762 -3.66479 -7160 4 47.1343 40.8792 20.2285 11.4236 3.93541 -0.385178 -7161 6 34.6613 36.4755 0.335066 -24.7851 30.4749 -21.6933 -7162 4 34.8743 36.0541 1.15687 -4.43901 -4.57192 24.0914 -7163 4 33.7851 36.9546 0.454416 30.1492 -20.7825 2.99091 -7164 6 52.5881 7.99834 30.4195 9.51271 -12.4348 0.483116 -7165 4 52.1042 8.76616 30.7719 -8.49213 -7.21741 -10.9068 -7166 4 52.0722 7.46347 29.7764 0.520668 12.6171 10.1624 -7167 6 32.0714 3.86484 29.4697 -9.7538 -17.9077 -31.6249 -7168 4 31.6702 2.97314 29.6052 7.93851 20.6113 2.31556 -7169 4 32.0839 3.94733 28.4741 0.539668 -3.17995 32.4864 -7170 6 20.3786 17.8365 28.6466 -12.59 16.0252 -12.2548 -7171 4 19.5397 17.5939 29.0718 10.0495 1.57584 1.91854 -7172 4 20.0545 18.3008 27.843 10.529 -6.18443 10.1885 -7173 6 30.4085 41.1704 41.0135 6.18506 -3.22706 -14.2809 -7174 4 30.53 40.7341 40.1581 -10.3332 2.11637 -0.589059 -7175 4 31.2241 40.9477 41.4498 10.7912 2.88832 12.9661 -7176 6 35.4567 32.8541 27.9296 20.1033 20.3116 -25.2142 -7177 4 35.1103 33.2872 28.7174 -1.27312 4.66796 4.01126 -7178 4 35.9087 33.5476 27.342 -15.0191 -24.2746 21.4934 -7179 6 14.3794 6.67806 12.7301 -1.9413 28.2373 -4.00169 -7180 4 15.2373 6.26429 12.8613 2.01848 -2.11516 -0.858514 -7181 4 14.5332 7.65903 12.7289 -3.54891 -27.4927 -2.87641 -7182 6 41.884 41.5441 20.3292 17.5267 3.97767 -7.39307 -7183 4 42.6467 41.3531 19.7473 -6.80228 5.43899 6.41045 -7184 4 41.2989 40.8038 20.1922 -8.54368 -4.96293 -3.75352 -7185 6 46.4016 22.5784 8.86191 7.75251 -10.6521 7.11129 -7186 4 45.8476 21.8716 8.52158 -12.3576 2.35246 -8.51817 -7187 4 47.0146 22.0703 9.39636 1.75986 6.35736 5.22437 -7188 6 17.4049 20.6472 13.8946 9.03444 14.2526 1.49725 -7189 4 17.6929 21.5842 14.0543 -8.3446 -25.4959 -7.46489 -7190 4 17.3265 20.4984 12.9333 2.034 6.01629 5.63707 -7191 6 8.18883 9.49722 13.352 -36.2403 7.79383 -0.838203 -7192 4 7.38606 10.0563 13.5919 32.9103 -12.129 -3.09847 -7193 4 9.02271 9.90793 13.6245 -5.40631 9.4956 5.41337 -7194 6 7.5857 14.8045 29.5864 0.660595 8.18183 -2.22865 -7195 4 7.08502 14.4366 30.3218 -1.52277 2.83209 3.37304 -7196 4 7.02502 15.474 29.1565 2.15616 -5.78955 1.98978 -7197 6 29.5787 39.2199 22.642 -23.9064 2.77655 4.40715 -7198 4 29.7923 38.7231 23.4359 12.3113 -5.95711 5.92816 -7199 4 30.3289 39.2945 22.0576 16.6647 -3.01011 -3.30282 -7200 6 19.7261 28.8048 8.43629 7.07867 10.1416 -1.30332 -7201 4 19.5094 27.8711 8.56662 5.24428 2.50367 -2.7317 -7202 4 20.6808 28.8901 8.64157 -12.3267 -4.04756 -0.658665 -7203 6 20.0918 21.6433 25.9098 -22.8378 18.9737 -2.62589 -7204 4 20.6828 21.9331 26.6394 -14.5657 0.991195 -11.6344 -7205 4 19.2872 22.2354 25.9429 24.6623 -16.2361 5.64257 -7206 6 12.7798 16.1171 22.7918 2.83481 -1.66518 -8.4999 -7207 4 12.1052 16.761 22.5802 -5.26913 11.1277 0.000470885 -7208 4 12.4145 15.3113 22.3987 5.67676 1.62415 3.74644 -7209 6 7.09341 27.2127 17.9852 -17.6727 17.6357 -2.43489 -7210 4 7.71878 26.5086 17.8851 15.5779 -18.3258 -2.50971 -7211 4 7.24623 27.7931 17.2297 2.82114 0.873921 -0.89624 -7212 6 32.4121 8.69011 34.8574 -11.3856 31.068 25.9423 -7213 4 32.686 9.10208 35.716 -2.62469 -14.8204 -24.695 -7214 4 31.4981 9.04705 34.7249 20.8054 -13.4625 -4.53694 -7215 6 50.3489 28.2274 17.5408 2.96892 -19.9668 3.87059 -7216 4 50.2931 27.3328 17.9381 -3.71715 13.2344 -0.552608 -7217 4 51.012 28.0828 16.8476 -2.81747 8.99858 -3.49204 -7218 6 15.6752 32.1523 25.7996 -24.1097 -1.02752 -8.0065 -7219 4 16.4469 32.5721 26.1513 19.1192 7.47953 7.03048 -7220 4 15.1241 32.8942 25.4834 5.39501 -5.59697 3.80799 -7221 6 41.2942 22.0009 29.6469 23.8016 -11.3242 12.4312 -7222 4 40.6197 22.5451 29.2897 -20.6362 19.5621 -14.8771 -7223 4 40.8321 21.2604 30.0334 -1.27155 -6.80964 4.85239 -7224 6 24.5512 12.7478 8.87624 0.539479 -2.56763 -16.1827 -7225 4 24.2317 13.5544 9.29419 1.48927 0.294937 0.678301 -7226 4 24.2485 12.8104 7.9491 4.47413 -5.17195 11.4459 -7227 6 47.3043 20.1171 10.4067 20.0451 13.2477 8.4905 -7228 4 48.2327 20.3756 10.3708 -0.951507 4.56311 9.88278 -7229 4 47.2371 19.5522 9.64912 -14.6685 -17.4861 -17.2657 -7230 6 17.6686 14.2187 29.9453 7.31834 -6.07886 -8.28437 -7231 4 16.8567 14.6777 30.1627 -12.3548 11.6861 -0.426412 -7232 4 18.1621 14.7508 29.3045 -6.68566 0.573373 4.02912 -7233 6 21.3468 34.5864 28.5404 1.3464 21.7174 -7.002 -7234 4 21.5866 35.4807 28.2285 -6.04705 -7.23946 1.73439 -7235 4 21.8012 34.5133 29.372 6.90897 -8.71765 12.9147 -7236 6 35.0919 4.05058 4.01374 -15.5825 9.30565 11.5721 -7237 4 34.2387 3.74233 4.43927 22.4566 16.9059 -11.4445 -7238 4 35.1406 5.04582 3.93988 -11.3656 -25.7387 7.52347 -7239 6 29.9083 8.58745 22.5962 -15.8002 1.46007 -28.7439 -7240 4 29.4293 8.33193 21.7391 23.5037 3.33824 36.5279 -7241 4 30.4512 7.83881 22.8901 -6.5033 3.48596 -7.29863 -7242 6 9.80484 32.9578 15.933 -3.40746 -8.77641 -12.0557 -7243 4 9.78146 31.9986 16.1651 13.0086 23.7442 4.23133 -7244 4 10.4547 33.4728 16.4465 2.19651 -19.1398 5.78046 -7245 6 24.9207 14.2283 32.5839 15.8568 -2.03515 22.8032 -7246 4 25.4679 14.491 33.3602 -10.7028 -6.65113 -14.6818 -7247 4 24.5651 15.0495 32.2637 -5.99659 7.67207 -7.30645 -7248 6 49.6599 21.9679 26.2292 42.3899 27.0609 3.31449 -7249 4 50.4576 21.5325 26.6526 -24.3124 13.7703 -9.69582 -7250 4 49.9726 22.89 25.9802 -16.6307 -33.6109 8.97028 -7251 6 39.2146 29.6271 28.776 1.2649 -6.72815 -4.66326 -7252 4 39.3113 29.0399 29.5368 -1.10705 1.67847 4.24024 -7253 4 39.5646 29.0864 28.052 -0.275695 2.9096 0.748968 -7254 6 50.692 34.7829 39.7485 29.9384 -8.83369 -9.14761 -7255 4 51.6379 34.6172 39.5245 -10.9597 10.0847 13.0799 -7256 4 50.284 34.1892 39.1195 -14.598 -6.88033 -5.74908 -7257 6 29.205 20.8761 19.5187 12.6622 -8.88768 18.517 -7258 4 30.1458 21.1462 19.5468 -10.0278 2.51211 -7.13483 -7259 4 28.7621 21.2804 18.7794 -5.02457 12.868 -15.5739 -7260 6 45.8413 1.41619 21.3894 -25.1775 13.0352 -19.0829 -7261 4 45.002 1.0285 21.6935 10.996 -3.183 3.42833 -7262 4 46.5512 0.981978 21.8333 16.3199 -17.0363 14.4799 -7263 6 26.0942 5.84138 12.9755 -8.81801 -1.79204 -2.94978 -7264 4 26.5644 5.00851 12.8396 1.48472 -6.22175 2.21387 -7265 4 25.1658 5.65249 12.7519 4.56693 -2.33816 -1.27821 -7266 6 9.00853 19.0479 23.7214 20.279 18.3012 -13.9253 -7267 4 8.07192 18.8993 23.8406 -12.3386 2.44029 -0.494901 -7268 4 9.09287 19.8709 23.17 -6.05991 -16.4473 11.9144 -7269 6 47.699 14.1778 40.0244 8.37408 5.46764 -8.11648 -7270 4 48.526 14.369 39.5365 -13.6583 -0.0280305 9.55934 -7271 4 47.2742 15.0291 40.2237 1.48315 -6.20176 -4.56159 -7272 6 47.9891 19.7944 0.501942 -52.5058 -34.5194 5.9677 -7273 4 48.5389 19.8149 1.25758 31.4646 9.24384 22.8657 -7274 4 47.3233 19.1101 0.79406 16.1078 24.936 -21.6052 -7275 6 27.1644 39.5895 31.4222 -35.4984 -42.2857 -13.2745 -7276 4 26.8828 40.2644 32.0188 2.45392 19.408 13.0965 -7277 4 26.334 39.0158 31.3353 32.2444 14.87 -2.1562 -7278 6 20.718 15.281 27.2921 -20.5288 29.0824 -25.1338 -7279 4 19.7916 15.5288 27.1303 0.0426049 -12.6319 11.5337 -7280 4 21.1251 16.0883 26.9354 13.4588 -8.377 2.43969 -7281 6 53.2931 3.12982 19.6939 21.059 35.3193 6.93312 -7282 4 52.5111 3.68486 19.642 -0.600406 9.66435 -1.15328 -7283 4 52.9649 2.26115 19.6482 -6.97037 -43.0252 -2.92507 -7284 6 40.7577 33.3874 24.037 12.7176 -1.25655 15.6318 -7285 4 41.575 33.1492 24.5319 -10.6485 3.51614 -11.0419 -7286 4 40.1417 32.64 24.1417 6.01104 2.31945 0.566227 -7287 6 50.2034 37.8915 21.3784 34.5696 42.4783 -9.46203 -7288 4 50.977 37.3667 21.5595 20.6596 -6.9612 4.63629 -7289 4 49.5128 37.3071 21.51 -51.1752 -39.6198 7.18684 -7290 6 41.3315 2.34663 21.9881 -5.34027 -0.787955 22.4754 -7291 4 41.3778 2.5308 21.0564 -4.51788 5.59338 -11.8441 -7292 4 40.4369 2.61524 22.307 16.348 -5.18373 -12.1741 -7293 6 3.68887 21.2797 14.3363 -13.7249 24.7693 -29.296 -7294 4 4.1389 21.9084 14.895 6.09004 12.6164 9.74183 -7295 4 3.85532 20.4521 14.7268 10.1618 -35.5887 19.7816 -7296 6 34.2749 11.1621 36.6211 6.86722 -26.3475 -8.98455 -7297 4 34.1457 10.3739 37.2084 1.76529 18.7936 -6.49638 -7298 4 34.0208 11.9523 37.0887 -10.0392 4.20616 19.2695 -7299 6 24.047 21.9251 23.4534 9.96695 -9.01801 9.45846 -7300 4 24.1056 21.4984 22.592 0.489969 -1.19981 -5.95122 -7301 4 24.6049 21.3417 24.0221 -10.3198 12.7259 -7.25629 -7302 6 18.8859 0.355593 4.41703 6.91373 -0.488994 13.8226 -7303 4 18.8848 41.346 4.15992 -3.4937 -3.21088 -8.69706 -7304 4 19.4141 0.350836 5.23016 -4.89519 7.76131 -7.17368 -7305 6 1.61894 7.82812 17.7388 11.0013 -2.20401 0.0755565 -7306 4 1.69825 6.91132 17.4299 0.598176 5.44338 0.144381 -7307 4 0.751076 7.92867 18.1276 -6.88769 -1.80246 0.772288 -7308 6 9.88357 31.5477 26.4865 20.7425 -47.9078 -25.9665 -7309 4 9.77347 30.8406 25.7562 4.13802 32.2768 29.9214 -7310 4 9.16637 32.1481 26.416 -28.5637 22.827 -5.6847 -7311 6 46.9801 33.0031 20.3665 8.92807 -2.6835 25.0439 -7312 4 47.1906 32.5959 21.2783 -12.5238 7.50902 -41.0074 -7313 4 46.473 32.3868 19.8049 3.08737 -2.68707 12.6131 -7314 6 49.5381 29.29 21.3848 5.35466 4.48298 6.61079 -7315 4 50.3596 28.8237 21.4263 11.6576 -22.6485 -14.6982 -7316 4 49.6544 29.7814 22.1942 -19.8316 15.0268 8.13943 -7317 6 13.5135 31.8933 19.1567 20.4477 19.0535 18.7588 -7318 4 12.9544 32.0303 19.9484 11.7182 -3.51681 -10.2564 -7319 4 14.3688 32.3555 19.4049 -26.6747 -15.4769 -10.5401 -7320 6 46.6242 34.0973 16.9259 3.25439 -22.1556 18.333 -7321 4 46.8986 34.1178 16.0034 3.18051 -0.659651 -5.23437 -7322 4 46.9878 33.2447 17.2966 -6.98741 23.2488 -14.973 -7323 6 19.7685 39.5238 2.42723 -1.93992 9.56528 -9.07466 -7324 4 20.504 40.1421 2.55739 -2.20075 -2.41675 -0.557551 -7325 4 19.2228 39.9982 1.75695 7.86662 -14.3322 13.7479 -7326 6 16.5372 9.39399 28.3106 5.81076 4.55242 0.698497 -7327 4 16.5228 10.3583 28.3138 -6.10914 3.2393 2.1867 -7328 4 17.4567 9.2086 28.1181 8.68803 -11.6531 -1.09187 -7329 6 3.04764 33.3834 8.9498 9.15555 8.47462 14.2626 -7330 4 2.34782 34.0603 8.86882 1.18173 -6.7492 -12.1187 -7331 4 3.16543 32.8691 8.13996 -9.91006 6.39371 -6.60301 -7332 6 49.6799 28.314 0.198287 -24.1009 9.02482 3.02524 -7333 4 50.5864 28.3416 41.8577 25.8797 -1.22492 -6.2647 -7334 4 49.539 27.5375 0.746128 -0.431885 -1.84115 5.43874 -7335 6 1.41501 6.84656 30.491 -4.80497 13.9866 22.936 -7336 4 1.80101 7.66454 30.873 3.64878 -10.2221 -13.1962 -7337 4 0.770406 6.61566 31.1883 9.6026 -0.286793 -13.8716 -7338 6 19.7721 9.41455 33.714 -8.86768 10.4812 -29.5452 -7339 4 19.9336 8.45599 33.7164 -2.74186 3.51224 -8.50186 -7340 4 19.4649 9.70036 32.7878 8.54711 -12.9815 34.2723 -7341 6 26.1689 11.9219 3.60877 17.3014 14.1658 -18.8808 -7342 4 25.6285 12.278 4.29668 -11.0155 5.7348 17.6305 -7343 4 26.0891 10.974 3.64129 -4.70103 -13.8965 4.54114 -7344 6 33.2526 2.15457 18.2061 -11.4346 36.8522 -3.73875 -7345 4 32.7853 2.99777 18.4754 10.6797 -23.9754 -11.6278 -7346 4 32.6748 1.45157 18.4903 -6.58847 -5.37306 4.71859 -7347 6 1.56641 29.1164 15.6218 -13.5802 38.9916 52.9136 -7348 4 0.75332 28.6899 15.9164 -2.28927 1.65734 -1.12046 -7349 4 1.88381 28.6368 14.9104 18.6776 -39.2188 -53.7174 -7350 6 41.7212 4.09992 39.5909 -11.2791 25.9615 -27.213 -7351 4 41.4168 4.81457 38.9155 6.653 -41.6332 33.8875 -7352 4 40.9635 3.53859 39.8438 1.60091 7.46224 -7.31473 -7353 6 28.6931 41.7984 21.1891 -6.68751 -8.42641 -4.80462 -7354 4 29.0735 0.780303 21.3271 9.25035 -16.558 -3.13259 -7355 4 29.3834 41.1221 21.0106 -2.7364 22.7931 4.70591 -7356 6 11.6395 12.4176 35.4525 -19.931 13.6599 -6.89173 -7357 4 11.6974 12.2316 36.3791 0.0383878 -4.43782 22.0781 -7358 4 12.5438 12.3774 35.1867 22.2579 1.64914 -11.6458 -7359 6 9.79005 12.0613 0.287125 39.0331 19.741 15.6941 -7360 4 10.6741 12.3652 0.649112 -24.288 -6.9143 -28.8601 -7361 4 9.37178 11.7496 1.07064 -16.9981 -12.0004 12.0483 -7362 6 48.1738 12.4001 9.21087 -14.7098 16.6281 -3.51107 -7363 4 48.3046 11.757 8.50338 5.36034 -5.93883 0.971929 -7364 4 48.886 12.3441 9.8545 11.7295 -7.72549 2.46367 -7365 6 20.1355 24.3829 18.9522 12.9308 -0.734849 -39.1055 -7366 4 19.4937 23.7815 18.5135 12.9255 8.80461 9.87411 -7367 4 20.8069 24.6162 18.234 -21.1698 -7.06963 26.7537 -7368 6 16.5393 31.2961 16.4761 -1.92172 -19.5246 -12.7122 -7369 4 16.66 32.2288 16.679 -4.64409 4.5232 17.4599 -7370 4 16.1207 30.7474 17.1716 1.36469 17.4989 2.94612 -7371 6 1.78169 14.6393 36.2977 19.9207 14.6923 -9.09136 -7372 4 1.03986 14.2937 35.8105 -15.9251 -7.35249 0.645581 -7373 4 1.68132 14.4688 37.2355 -8.64532 -4.94464 12.0587 -7374 6 4.36624 29.2084 29.5903 15.7403 17.1522 -11.4447 -7375 4 4.94475 28.7816 30.2313 0.42296 -3.8665 4.22363 -7376 4 4.9316 29.8996 29.1557 -19.5902 -17.4666 6.54186 -7377 6 43.6839 0.248111 22.6506 -19.7732 -13.3298 -9.50689 -7378 4 42.8764 0.661685 22.3065 0.028666 2.48852 1.60322 -7379 4 43.5183 41.2016 22.5042 11.2477 10.9397 1.57875 -7380 6 52.4994 40.9828 27.2386 -0.538127 -6.12089 -28.931 -7381 4 52.76 40.8447 26.286 -9.02638 3.90908 21.7421 -7382 4 53.2684 41.4137 27.6303 2.05735 4.02476 1.85103 -7383 6 25.5814 23.8969 27.7396 -24.7861 2.98762 0.531627 -7384 4 24.718 24.3642 27.6072 20.4038 -13.4527 4.15226 -7385 4 26.2821 24.4835 27.457 3.8963 1.45656 -1.88052 -7386 6 23.1228 17.031 33.3243 -5.52517 1.23961 5.4323 -7387 4 23.1399 17.5083 34.1558 0.441881 0.23205 -0.480567 -7388 4 22.8557 16.1383 33.5546 -4.67547 -8.64305 1.56256 -7389 6 2.92722 11.8725 21.3561 -41.4423 -19.1296 -19.7046 -7390 4 2.18606 11.2638 21.6443 29.5918 21.1066 -8.34803 -7391 4 3.54191 11.9259 22.0595 17.1072 -0.484489 21.5157 -7392 6 2.18317 4.15265 30.0257 5.779 -9.3787 -10.7468 -7393 4 2.12921 5.11001 30.0802 -2.76576 12.2821 -0.843831 -7394 4 2.67493 3.96573 29.2018 -3.29095 2.88479 4.98522 -7395 6 26.6728 30.2949 13.4768 7.17255 0.654769 14.1147 -7396 4 25.7117 30.2905 13.6467 8.22624 -2.44269 3.31295 -7397 4 27.1112 30.3188 14.3546 -11.9073 -0.623098 -17.8849 -7398 6 24.8734 30.8117 10.8292 -29.6944 -3.60301 -2.53615 -7399 4 25.2254 30.0431 10.3884 7.40196 -6.71761 -6.36825 -7400 4 25.5983 31.2424 11.2381 22.0508 11.6497 12.6203 -7401 6 53.1723 24.107 4.51212 -8.50651 -29.3458 16.902 -7402 4 53.5087 24.8189 4.00388 11.9327 21.9784 -14.7749 -7403 4 53.9335 23.6869 4.92936 2.49868 2.30602 2.88115 -7404 6 24.9006 4.49574 23.9943 -15.2803 12.8054 -1.91421 -7405 4 24.3197 5.26112 23.9044 -17.3839 -11.7779 6.16284 -7406 4 25.6928 4.95696 23.7819 42.3091 -2.82475 -3.31223 -7407 6 34.6808 1.64534 41.2582 -1.16689 -16.4189 -19.1193 -7408 4 35.6107 1.42238 41.0689 -7.35569 3.11738 8.02352 -7409 4 34.6894 2.06091 0.199506 5.11707 10.3461 19.9542 -7410 6 13.3318 19.5273 16.3875 10.456 -31.2285 9.008 -7411 4 13.8245 19.0713 15.6714 -4.89067 6.02882 4.66139 -7412 4 13.1633 18.7854 17.0362 1.8233 23.0525 -16.1268 -7413 6 48.6827 0.169575 20.4108 24.7259 -31.926 -14.6767 -7414 4 49.2893 41.6148 19.7702 -18.6338 21.3246 17.3218 -7415 4 48.933 41.6689 21.2514 -6.5025 5.85221 0.333279 -7416 6 43.0578 27.7881 11.5189 -10.6888 1.76469 -10.0665 -7417 4 42.6538 28.0077 10.6554 5.1393 -6.0393 10.108 -7418 4 43.5199 28.5835 11.7935 3.33621 0.984046 2.36511 -7419 6 25.7084 21.3766 35.1933 7.92601 18.71 -2.37973 -7420 4 25.8037 22.0957 34.5091 -5.30878 -22.9017 16.0752 -7421 4 25.4462 20.5484 34.7558 3.58761 11.0813 -0.636196 -7422 6 44.7325 4.60288 27.7529 -5.18995 0.47983 -9.95788 -7423 4 44.2388 4.02478 27.1463 1.34738 -4.40857 1.63455 -7424 4 44.3371 5.47709 27.6067 3.7052 -1.13476 4.16529 -7425 6 41.2786 11.441 34.2043 -0.416747 21.9122 -5.07112 -7426 4 40.7165 11.5703 33.4237 0.0697438 -4.14349 0.395824 -7427 4 41.2047 10.5155 34.4107 -4.51201 -19.8544 2.93408 -7428 6 19.8751 36.6454 2.03332 12.5662 31.6724 6.60432 -7429 4 20.6794 36.321 2.43856 -1.22315 -24.7147 -1.51883 -7430 4 20.0441 37.6041 2.15193 -20.0718 -8.75186 -9.57731 -7431 6 27.484 4.65653 6.35518 1.28922 -40.4385 -58.6648 -7432 4 27.5497 3.77116 6.72735 -1.75384 3.56143 11.9553 -7433 4 27.4257 5.33486 6.97498 -2.79123 31.4549 44.9969 -7434 6 16.8428 30.7659 39.9509 7.31092 -42.6244 -5.47757 -7435 4 16.9464 31.3097 40.7337 2.60533 1.47109 13.0941 -7436 4 17.1496 29.8303 40.1512 -5.48449 28.5555 1.20442 -7437 6 51.1542 15.2049 16.3406 35.1838 19.4064 -24.6303 -7438 4 51.2473 16.0791 15.87 -9.06363 -20.4986 13.944 -7439 4 52.0128 14.747 16.0894 -33.4595 8.32861 13.6861 -7440 6 49.9911 21.2271 35.9695 16.4294 -24.4585 13.2328 -7441 4 49.3547 21.5056 35.3276 -17.8928 6.13619 -17.6667 -7442 4 49.9245 20.2453 36.0087 2.29216 20.3869 -1.95357 -7443 6 34.4275 0.15221 5.68266 -0.837995 23.3079 0.855413 -7444 4 34.2957 0.929489 6.27037 2.93096 -11.6463 -16.4536 -7445 4 34.3488 0.459476 4.74482 0.623699 -7.30698 18.2278 -7446 6 48.316 11.5365 19.8846 -3.65813 -3.14803 11.8504 -7447 4 47.8503 11.3247 20.7373 6.31016 14.4835 -28.1035 -7448 4 47.7834 12.1052 19.2757 1.33379 -13.4076 20.6299 -7449 6 4.19577 39.4409 13.3607 25.3524 9.34899 10.5928 -7450 4 4.92582 39.74 13.9847 -33.0668 -7.48624 -17.3574 -7451 4 3.31127 39.5736 13.758 11.9971 1.78205 4.76714 -7452 6 8.7457 16.1809 8.53298 -1.62633 17.1572 -22.0575 -7453 4 8.74512 16.8853 9.19115 0.0519099 -7.3494 1.25428 -7454 4 8.72812 16.6658 7.66651 -0.023414 -16.7756 16.7144 -7455 6 29.0271 14.2712 26.5342 -13.8591 45.9397 20.1216 -7456 4 29.0757 15.2697 26.7309 6.93185 -43.1811 -12.6551 -7457 4 28.1042 14.0702 26.7795 9.9397 -3.04712 -3.53591 -7458 6 27.3813 14.5204 8.1419 -14.0666 1.8718 0.247246 -7459 4 26.4091 14.3966 8.10069 17.9482 5.30051 2.04476 -7460 4 27.5539 15.4689 8.31094 -4.76419 -14.5771 -1.3831 -7461 6 14.1301 27.2156 32.9232 24.3629 15.6041 -10.7258 -7462 4 14.926 27.3266 33.4685 -8.09546 -2.45296 -2.52419 -7463 4 13.4702 26.8045 33.4616 -14.5983 -10.6772 12.2116 -7464 6 31.6563 35.7792 21.2709 -29.1401 -25.1051 5.88501 -7465 4 32.0219 36.5153 21.7512 6.27263 14.1007 6.62418 -7466 4 30.8825 35.462 21.8184 22.9209 7.6802 -13.887 -7467 6 54.2186 28.7134 16.8958 -10.3287 11.0002 2.01575 -7468 4 53.5002 28.4234 16.309 3.24852 -2.61584 3.16662 -7469 4 53.9524 29.6107 17.1726 0.515277 -7.78004 -0.375364 -7470 6 9.0512 5.27483 17.1492 25.6572 1.38615 -17.9054 -7471 4 9.89534 5.12229 16.6101 -31.8522 3.085 22.1798 -7472 4 8.85255 6.23494 17.0921 1.81156 -15.0607 2.57474 -7473 6 29.6868 9.77258 26.5671 22.9889 -14.8503 10.4327 -7474 4 30.5444 9.2887 26.5838 -17.3341 11.3615 1.53321 -7475 4 29.3655 9.78642 27.4819 2.88877 -1.07091 -0.346791 -7476 6 44.0288 31.1766 32.1743 -14.2068 1.02328 22.4178 -7477 4 43.2475 30.9789 32.739 9.50682 -2.17476 -16.522 -7478 4 44.5788 31.7142 32.7564 8.88854 3.82935 -1.95952 -7479 6 53.49 3.62433 25.1454 11.2777 4.02107 -26.8953 -7480 4 54.1404 4.33507 25.1993 -2.49783 6.11479 15.045 -7481 4 53.6886 3.29227 24.2489 -10.294 -6.80459 12.4065 -7482 6 12.451 22.8746 3.38821 10.4278 8.96452 22.9237 -7483 4 12.7779 22.025 3.15024 17.1772 -24.972 1.67394 -7484 4 11.7815 22.9738 2.74712 -31.3784 16.165 -21.5343 -7485 6 39.42 29.6871 0.722943 17.2287 20.3893 -0.939439 -7486 4 39.938 29.1007 0.168548 -5.00448 -5.71086 -1.61555 -7487 4 38.6697 29.2119 1.03517 -14.5725 -11.7208 3.22357 -7488 6 13.7451 37.8179 23.0399 -3.65878 -32.3471 -6.65898 -7489 4 14.6418 38.0465 23.3627 -20.7195 15.519 -6.09735 -7490 4 13.1315 38.5597 22.9108 15.1185 11.2609 5.5967 -7491 6 33.3417 41.2334 -0.000336223 20.2285 27.8942 26.4667 -7492 4 33.8463 0.176253 41.7571 -17.5829 -26.3423 -4.93882 -7493 4 33.4991 41.0748 0.960438 -12.6248 -4.93214 -20.7453 -7494 6 15.7246 3.51737 6.33987 10.6879 -4.05507 31.4744 -7495 4 14.9251 3.29652 6.83809 -1.96505 1.65417 1.3128 -7496 4 15.4345 3.71468 5.4634 -8.944 6.24557 -22.4591 -7497 6 27.7713 30.7539 5.06912 -9.69485 -19.9648 -11.4393 -7498 4 28.5319 30.6575 5.66481 -7.77203 -4.90526 -3.90413 -7499 4 27.6074 29.8515 4.67882 9.36195 16.9347 11.4385 -7500 6 13.3277 7.57287 23.3467 18.1651 -5.37845 17.9429 -7501 4 14.1986 7.86136 23.0073 -11.0143 -2.49266 1.50668 -7502 4 12.7134 7.55433 22.6278 -8.93981 2.52131 -14.7715 -7503 6 38.3049 37.3174 27.9983 8.70135 -12.5747 15.655 -7504 4 38.3154 37.3922 27.0572 -6.74668 8.75695 -30.2201 -7505 4 39.0324 36.7087 28.1704 1.61648 -2.88985 11.5174 -7506 6 35.8266 12.5392 12.0897 -2.57405 -7.53067 12.8361 -7507 4 35.6491 11.5922 12.0112 2.97069 1.46586 -4.70523 -7508 4 36.2655 12.8127 11.2954 6.10525 2.83369 -11.8718 -7509 6 52.1153 23.0889 41.2774 53.3714 4.98692 -14.9993 -7510 4 52.5505 23.0114 40.3503 -31.9828 -2.74691 35.5054 -7511 4 51.1752 22.9201 41.2974 -16.3051 -5.99839 -13.4785 -7512 6 39.5458 11.6586 16.6081 -4.87816 2.10267 -34.9091 -7513 4 39.8889 10.7596 16.6462 4.61035 -3.54577 11.4771 -7514 4 39.4661 12.017 17.4857 2.58954 -3.33375 20.5696 -7515 6 0.680688 9.01153 7.97148 24.3969 36.1639 -33.0882 -7516 4 54.7452 9.01592 8.14854 -24.8099 -10.5681 8.91807 -7517 4 1.15172 8.32837 8.40327 2.66278 -26.2854 21.5078 -7518 6 42.3319 28.747 39.482 14.4944 54.9029 13.7373 -7519 4 41.6099 28.5069 40.0315 -24.977 -16.9351 14.372 -7520 4 42.5658 28.0062 38.9777 10.1954 -37.5926 -27.6332 -7521 6 38.7351 30.2774 16.2793 4.0737 2.19128 11.2593 -7522 4 38.8758 29.8829 17.1681 -0.562728 7.98522 -10.8415 -7523 4 39.3736 31.0181 16.2214 -9.64538 -12.7452 3.65311 -7524 6 7.59373 18.0328 0.655349 -39.2466 -13.429 1.02247 -7525 4 7.12412 17.545 1.38102 15.2508 10.2608 -15.5396 -7526 4 8.49503 18.0746 0.920891 28.7098 -1.69475 13.4339 -7527 6 33.7283 34.5883 24.1367 2.81913 -0.677006 -1.55035 -7528 4 33.5209 35.3543 23.5868 -0.36085 -2.23271 3.31185 -7529 4 34.0202 34.925 24.9956 3.1898 -0.550642 -1.12415 -7530 6 16.0108 40.0553 39.5926 -11.937 1.54577 -14.812 -7531 4 16.9471 40.1686 39.433 15.7688 -0.191962 4.71606 -7532 4 15.632 40.0274 38.6953 -1.55756 -1.47356 6.94311 -7533 6 4.49381 37.1265 21.8421 33.1234 -31.7004 -39.5319 -7534 4 4.78916 37.7556 22.4729 8.60512 21.3704 21.7375 -7535 4 5.32421 36.8863 21.3047 -36.9575 7.65083 16.8008 -7536 6 39.2568 20.1405 31.3294 -11.3601 -2.01094 -17.3558 -7537 4 39.2441 20.8952 31.9186 1.64276 10.2876 11.6417 -7538 4 38.6708 20.3662 30.5789 5.24327 3.39586 9.04201 -7539 6 28.5615 6.15748 32.0463 -1.77815 -13.6106 -5.56393 -7540 4 29.3688 6.39317 32.5024 4.03477 3.32162 5.90581 -7541 4 28.0645 6.97719 31.936 3.86184 3.53187 3.02469 -7542 6 9.32925 11.326 38.2021 -45.7357 8.82179 -18.9514 -7543 4 8.63026 12.0506 38.2047 26.1946 -20.5574 6.08922 -7544 4 8.95275 10.6938 37.5333 17.8336 11.1262 12.3014 -7545 6 41.6094 10.4714 6.86105 10.1449 -2.02989 30.4141 -7546 4 41.8033 10.1647 7.80154 -6.16714 11.7455 -31.3638 -7547 4 41.7667 11.4361 6.82819 -2.03628 -11.6206 -3.02795 -7548 6 3.11959 28.1093 17.6239 10.7497 -46.175 24.4008 -7549 4 2.68352 28.5892 16.9552 -19.7085 26.1099 -29.6067 -7550 4 3.57016 28.7359 18.1797 1.91623 14.188 4.79643 -7551 6 39.3448 12.237 19.2548 -14.1137 14.4353 18.1644 -7552 4 39.3198 13.2124 19.4672 -0.23776 -25.4214 -5.72266 -7553 4 38.5957 11.8144 19.7397 13.7352 7.639 -10.0067 -7554 6 2.76578 9.12322 31.711 10.2249 -26.7767 20.5709 -7555 4 3.2959 8.42892 32.18 -23.1647 11.967 -1.06293 -7556 4 3.41205 9.47362 31.1162 6.35119 16.2437 -14.7539 -7557 6 47.0978 34.3186 24.1743 26.4285 -20.6373 22.1669 -7558 4 47.9222 34.8155 23.9694 -26.3889 2.76484 -4.38573 -7559 4 46.3048 34.7125 23.8251 -6.69439 19.4391 -11.1209 -7560 6 41.2781 35.6191 9.5379 -9.82526 -0.200667 -5.59214 -7561 4 40.3156 35.6289 9.77314 20.3165 9.2235 -0.933793 -7562 4 41.677 36.5159 9.62264 -17.3348 -12.0484 0.717846 -7563 6 20.4662 31.4486 3.15039 -21.7086 3.64016 -5.07598 -7564 4 21.0332 31.2208 3.90109 -5.23001 0.711793 3.99895 -7565 4 19.5233 31.6154 3.43158 26.7394 -6.53789 -0.258783 -7566 6 33.2215 17.9623 24.8097 -0.453891 -1.34226 7.30289 -7567 4 34.1788 17.9667 25.0617 -18.0356 9.24084 -3.8919 -7568 4 32.8105 18.8566 24.8334 12.2893 -13.6267 3.75162 -7569 6 40.152 39.887 35.7648 -20.6867 7.32712 26.7748 -7570 4 39.5869 39.7633 34.9934 2.3303 1.35559 2.0998 -7571 4 39.5428 40.1203 36.5292 18.9615 -7.74514 -25.9591 -7572 6 4.86846 34.7127 16.4904 2.99496 1.45153 -7.51648 -7573 4 4.94748 35.6438 16.2302 0.473437 -5.16658 -0.520329 -7574 4 5.67201 34.2663 16.1683 2.12015 0.152524 1.06444 -7575 6 19.1332 11.0374 26.5471 0.604362 14.7011 2.3555 -7576 4 19.0986 10.7741 25.6217 -2.73437 -5.06461 -1.05922 -7577 4 19.4813 10.3027 27.0576 -1.53582 -10.5153 -0.687646 -7578 6 54.0201 13.9196 34.7874 -7.69802 -2.07317 -2.05829 -7579 4 53.0764 13.9769 34.9536 -3.33021 -5.1824 4.14914 -7580 4 54.0417 14.262 33.8952 13.8623 5.56658 -9.2157 -7581 6 1.84699 20.6587 5.20972 14.9439 0.361847 -39.2318 -7582 4 1.3018 19.9191 4.88605 -0.816153 4.45331 11.6833 -7583 4 2.38828 20.8916 4.39492 -13.6739 -1.13034 29.3331 -7584 6 22.2428 0.0912174 14.2544 2.10511 -1.36215 24.2926 -7585 4 21.4939 0.626329 14.4934 -11.4394 6.88953 -7.77601 -7586 4 22.6568 41.86 15.1175 2.53583 -3.69112 -10.285 -7587 6 4.95629 7.04242 24.7427 6.31781 -9.23371 -7.19194 -7588 4 4.17782 7.32111 24.2434 0.969413 4.1364 5.47863 -7589 4 5.24611 6.21648 24.3187 1.32276 5.05146 9.71893 -7590 6 41.4805 20.8726 34.9438 -11.2314 22.7349 11.4525 -7591 4 42.1022 20.1554 34.9949 12.4759 -11.6791 0.0999164 -7592 4 41.5325 21.3468 35.8092 3.20944 -13.6901 -15.0483 -7593 6 28.2157 1.74547 31.725 -9.95228 -2.94536 5.02618 -7594 4 27.5723 1.08944 32.0352 4.54694 0.234407 -12.282 -7595 4 28.3302 2.26918 32.5198 6.68924 9.49254 2.75715 -7596 6 16.8899 27.3746 36.9858 -9.49677 -4.03922 3.2671 -7597 4 17.2157 28.1459 36.4964 2.86939 -7.49192 -2.31982 -7598 4 17.0938 26.5386 36.5152 1.89463 15.2676 -1.69393 -7599 6 26.8243 38.069 8.34482 13.7761 41.6132 3.1747 -7600 4 26.4823 38.3279 9.22598 3.84792 -18.6223 -11.4711 -7601 4 26.785 37.1424 8.19579 -7.88027 -37.9853 9.71444 -7602 6 26.6634 33.7911 23.2273 -21.2745 -8.43567 7.74896 -7603 4 27.1019 33.3181 22.5212 7.04537 -0.372104 -6.32159 -7604 4 27.3305 34.169 23.7872 14.5385 6.50935 5.10733 -7605 6 10.2166 27.1183 30.2276 16.2509 -17.1331 -9.46175 -7606 4 10.1765 28.0583 30.3796 2.29392 15.9864 2.71565 -7607 4 10.9387 26.9511 29.5696 -14.5483 8.58048 15.0042 -7608 6 47.87 12.5975 5.02268 -6.13754 10.9902 -1.31963 -7609 4 48.1357 13.4822 5.34438 -4.36861 -17.8106 0.719643 -7610 4 48.2725 11.9144 5.56853 6.38614 1.6905 7.47062 -7611 6 53.3393 24.5639 22.1523 -40.2275 -1.43509 1.91788 -7612 4 53.1884 24.513 23.11 6.12251 -0.709171 0.80005 -7613 4 54.2538 24.6676 21.944 28.1496 2.10984 1.66559 -7614 6 29.4072 10.7569 19.3822 52.4151 15.8336 -9.71081 -7615 4 29.248 9.98119 18.8618 -10.0643 -15.3346 -6.0739 -7616 4 28.6282 10.9567 19.8417 -45.3483 4.87471 22.9978 -7617 6 39.4757 14.9522 19.5461 30.0359 -1.30311 42.0602 -7618 4 40.386 15.231 19.9108 -38.5728 -7.77311 -23.4682 -7619 4 39.3498 15.357 18.6983 1.75067 15.7407 -16.9704 -7620 6 32.8823 15.9838 22.806 -0.988113 9.61369 -4.64335 -7621 4 32.9657 16.5376 23.5815 3.43203 16.8704 5.79609 -7622 4 32.7087 15.1359 23.1895 -5.55033 -22.0541 3.57771 -7623 6 30.5481 1.96835 21.5144 8.4955 -1.31523 7.25762 -7624 4 30.7645 2.06729 22.4547 -1.5525 1.72807 -3.05596 -7625 4 31.3563 1.607 21.1075 -12.3766 3.94884 0.453046 -7626 6 0.972615 11.9937 3.31932 2.75381 16.0475 9.69945 -7627 4 1.12058 12.9582 3.29011 -6.67466 -9.20629 -8.78254 -7628 4 1.16803 11.7633 4.23669 1.49118 -7.35844 2.879 -7629 6 32.1487 30.4035 20.7885 -10.2937 2.79415 -8.64413 -7630 4 32.9584 30.6778 20.3377 1.19491 2.22071 -1.75985 -7631 4 31.4018 30.7106 20.2304 12.8433 -5.61998 7.3235 -7632 6 5.36663 35.5196 9.0005 -13.7636 -10.8617 -1.51226 -7633 4 5.10558 35.6694 8.09522 3.88385 7.21083 -8.97177 -7634 4 4.84313 34.7327 9.21079 3.19207 0.561776 9.20467 -7635 6 49.9075 13.051 32.2032 24.7068 -1.78611 -22.7634 -7636 4 50.5917 12.8604 31.4934 -20.1594 10.2365 23.451 -7637 4 49.3072 12.3042 32.1357 -5.12737 -3.80929 6.93874 -7638 6 4.31321 24.0956 1.58545 -15.4175 -15.0012 -21.2972 -7639 4 3.62325 24.7374 1.73273 -2.73087 12.0747 8.21305 -7640 4 3.96758 23.5799 0.823479 15.3265 9.07188 13.8923 -7641 6 44.1581 38.1227 12.3545 -1.42535 -29.4608 0.820402 -7642 4 43.4877 37.5183 12.7749 7.78878 22.0847 -6.23147 -7643 4 43.9706 39.05 12.5061 -8.83193 8.8938 6.46859 -7644 6 44.688 17.3349 22.7943 52.857 -4.21013 7.29678 -7645 4 45.2391 18.0521 23.242 -20.6522 -19.8992 -14.1432 -7646 4 45.3699 16.6167 22.57 -26.4285 25.231 9.0384 -7647 6 20.3608 11.6914 19.667 7.58964 -15.1508 -20.1027 -7648 4 20.0231 12.466 20.0832 -9.22037 21.7722 17.9466 -7649 4 20.541 12.011 18.7627 0.78957 -9.8802 4.31695 -7650 6 4.45783 15.4051 36.2022 4.17523 -10.6616 -1.13379 -7651 4 5.07913 14.7124 35.8925 -4.22209 9.46347 0.0108161 -7652 4 3.57023 15.0045 36.1544 3.18966 5.51307 1.04981 -7653 6 44.8105 39.5245 30.1712 -12.2097 -12.5983 -29.4865 -7654 4 44.6649 39.2374 29.2388 12.2423 8.81859 19.2473 -7655 4 44.0848 39.0946 30.6384 -0.298867 5.38951 7.86823 -7656 6 30.0635 3.50956 11.3278 16.0802 -2.39158 -40.3094 -7657 4 30.5444 4.30508 11.007 -11.8296 -5.04519 20.5985 -7658 4 30.1379 2.92562 10.5291 -8.6007 1.99314 24.6663 -7659 6 25.6288 24.8657 16.1423 35.3146 -5.68436 -0.158812 -7660 4 26.5897 24.7732 15.9989 -9.69879 -4.30362 -13.2764 -7661 4 25.6615 25.1054 17.0605 -14.6317 7.6504 23.2411 -7662 6 36.8074 29.8609 20.6529 -16.3286 -4.81766 17.6852 -7663 4 35.9316 30.2459 20.3982 14.0867 -8.19012 9.60149 -7664 4 36.7164 29.3161 21.4988 -1.56746 21.2483 -31.978 -7665 6 52.2273 17.0565 38.3075 -18.6216 -30.1938 15.1193 -7666 4 51.4912 16.4635 38.6201 23.7372 14.7716 -7.00173 -7667 4 51.7959 17.5937 37.6524 -0.777677 7.661 -6.77585 -7668 6 3.82637 23.6296 29.8591 26.0466 24.015 14.1033 -7669 4 4.67122 23.3872 29.4436 -4.98409 -4.75234 -2.50433 -7670 4 4.14214 24.3103 30.5173 -20.0237 -17.5461 -14.7603 -7671 6 6.36694 19.9104 41.0994 -7.87156 6.69529 -0.551213 -7672 4 6.75531 19.2216 41.6418 3.91706 -4.8357 7.00798 -7673 4 6.43687 20.7189 41.61 0.371167 5.3541 9.12827 -7674 6 28.9069 38.9219 35.3342 18.1363 5.4885 19.4373 -7675 4 28.4975 38.2544 34.8057 -13.0204 -17.6003 -18.1497 -7676 4 29.7244 38.4883 35.6529 -6.84193 6.3312 -4.3373 -7677 6 1.06391 30.294 34.4744 17.4659 -4.25802 33.126 -7678 4 0.923806 29.8092 33.6831 -4.92213 -16.9626 -31.6436 -7679 4 0.43107 31.0027 34.4841 -13.3738 11.5818 -2.38269 -7680 6 26.4433 22.0338 20.438 10.4135 -19.5508 3.73058 -7681 4 27.3849 22.2767 20.3653 -17.5193 8.20183 -1.91668 -7682 4 25.8117 22.75 20.2981 5.30742 7.62512 -2.77887 -7683 6 3.9439 18.647 22.686 19.6053 -30.212 14.064 -7684 4 4.76982 18.631 23.2404 -22.0254 9.00566 -12.7221 -7685 4 3.71052 19.5535 22.5456 -1.30938 28.7031 -1.82281 -7686 6 6.87955 39.3273 26.9921 -1.67667 -12.9446 -11.9216 -7687 4 7.1836 39.9129 27.6984 -12.429 3.42242 7.34442 -7688 4 5.90054 39.2886 26.9896 13.9064 15.8094 12.8698 -7689 6 43.976 41.7556 26.5281 4.8347 -4.89589 -5.39334 -7690 4 43.9038 0.242071 27.3891 4.48323 5.1383 20.2804 -7691 4 43.1144 41.9148 26.1591 -17.5097 2.26447 -13.804 -7692 6 31.7137 29.57 16.9845 -29.8695 1.84649 5.70955 -7693 4 31.0051 28.8814 16.8861 15.511 13.0746 -1.88966 -7694 4 31.2475 30.3377 17.3963 12.872 -19.7765 -2.8161 -7695 6 46.2467 10.9544 15.5549 14.6537 -15.0388 13.4913 -7696 4 45.2992 10.7621 15.4719 2.35584 -6.3837 2.44855 -7697 4 46.7422 10.1008 15.6673 -18.7057 18.8904 -8.1417 -7698 6 36.5806 15.025 25.8165 21.8026 1.76557 9.13915 -7699 4 37.3648 15.4873 26.2149 -21.7037 -15.0217 -10.3096 -7700 4 36.1201 14.6319 26.5704 -2.31195 -1.95921 2.19148 -7701 6 47.2758 22.6707 6.12549 -20.393 21.5378 -17.5673 -7702 4 46.5536 23.2672 5.80637 16.9751 -15.6011 5.88158 -7703 4 47.0174 22.4855 7.02503 2.56882 -3.04752 8.65489 -7704 6 27.5281 39.6653 17.8063 9.11062 13.5998 -14.667 -7705 4 26.6008 39.6971 17.5421 -9.18871 -3.65478 0.40423 -7706 4 27.5952 39.1072 18.5692 -4.91094 -8.97362 13.813 -7707 6 14.0432 27.9674 36.8911 6.42031 -13.692 3.20322 -7708 4 13.4093 27.2386 36.6831 22.3711 16.0651 -1.21324 -7709 4 14.9745 27.6178 36.9209 -23.5128 3.35359 -2.56993 -7710 6 33.7582 13.0225 13.8549 2.82411 10.3644 -10.1378 -7711 4 34.6192 13.1187 13.3682 -26.1927 -14.0119 11.7219 -7712 4 33.447 12.1034 13.9061 16.5995 3.21583 -3.74575 -7713 6 3.39066 17.4794 1.96807 -11.027 -24.2448 -29.9928 -7714 4 3.01559 16.7425 1.36999 17.4474 35.7284 24.3857 -7715 4 3.43148 18.2603 1.39088 -0.910914 -5.0095 5.82543 -7716 6 27.5636 2.76805 36.4448 23.3016 6.40537 7.49337 -7717 4 28.0874 2.94382 35.6362 -14.0128 -4.70143 5.95918 -7718 4 26.7201 2.39292 36.1778 -1.1877 -0.145823 -5.22631 -7719 6 21.3174 1.20043 18.721 3.60184 -34.5623 26.1973 -7720 4 20.9731 2.06802 18.64 -8.90193 33.3239 -10.7294 -7721 4 20.989 0.903829 19.6038 6.52339 -1.5964 -17.0558 -7722 6 11.8953 16.678 29.2972 -24.0209 -12.1876 15.7906 -7723 4 10.9907 16.5502 28.9196 20.2967 4.53139 4.03679 -7724 4 11.83 16.2797 30.2084 5.50538 14.3948 -24.2902 -7725 6 15.9723 29.4609 29.6333 0.682268 26.1612 18.9471 -7726 4 16.8848 29.3174 29.3467 -1.47573 8.2327 2.84191 -7727 4 15.9822 30.2485 30.2615 3.64459 -27.0302 -18.4378 -7728 6 42.9269 7.03734 4.5197 11.663 -6.03152 6.53833 -7729 4 43.4231 7.50219 3.8104 -1.91258 -11.2042 14.7177 -7730 4 43.564 6.5391 5.10838 -14.9069 13.4822 -19.2581 -7731 6 46.4099 26.3175 18.5001 -14.65 2.77244 -10.2078 -7732 4 46.6739 27.1133 19.0164 -10.4759 -17.1195 -12.5948 -7733 4 45.7242 26.5969 17.8403 16.3643 -1.95791 15.5671 -7734 6 26.8576 31.9381 30.1176 11.4414 -26.9795 -35.8502 -7735 4 27.1259 30.9869 29.8859 -9.79711 36.6724 15.314 -7736 4 26.5998 32.3006 29.2227 5.46388 -10.7605 29.9307 -7737 6 19.4818 37.6192 31.2596 -32.5143 -22.3469 33.0613 -7738 4 19.0962 36.8501 30.8088 8.72557 8.52431 -5.84089 -7739 4 19.0944 37.5229 32.1795 16.9146 13.3756 -22.466 -7740 6 52.3665 32.7318 12.7942 -5.34222 7.33615 -3.08781 -7741 4 51.884 32.8768 11.9489 17.9119 0.95058 7.1847 -7742 4 53.27 33.1068 12.8183 -18.0778 -3.45769 -11.3622 -7743 6 6.73992 9.26339 24.0285 -18.4022 -33.2824 -0.456279 -7744 4 6.43016 9.52976 23.1488 2.39009 0.543925 -1.37305 -7745 4 6.14044 8.50785 24.2751 15.0572 15.2043 -3.93749 -7746 6 39.7373 39.5658 25.499 -11.0807 -5.52867 0.517577 -7747 4 39.7453 38.628 25.2585 2.77876 5.57729 -0.31401 -7748 4 38.826 39.699 25.8216 4.65786 0.889055 -1.26295 -7749 6 24.0734 14.0105 21.1438 13.9648 5.3121 -25.5312 -7750 4 23.6065 13.6215 21.8839 -3.42696 -11.6299 6.48748 -7751 4 24.3304 13.3134 20.491 -9.48085 14.6929 20.6508 -7752 6 5.1987 41.7736 24.8713 10.0047 -19.0707 10.1325 -7753 4 6.05769 0.0475547 25.2635 0.547146 -1.74599 -5.91735 -7754 4 4.86042 0.69526 24.5593 -4.41349 12.4443 -5.8689 -7755 6 42.3687 20.86 21.2777 19.2234 -22.1312 -1.40502 -7756 4 42.3783 20.5581 22.1846 0.624409 -1.73106 8.2154 -7757 4 41.7113 21.532 21.2665 -20.5735 20.428 -5.9858 -7758 6 48.2425 15.3687 33.5924 -0.241089 -2.38933 -5.28694 -7759 4 48.6415 14.7162 33.0072 6.18243 -4.87195 3.86709 -7760 4 47.6596 15.8553 33.0028 -7.11438 7.34599 -0.780278 -7761 6 46.0202 38.2953 16.5865 15.7829 17.4793 7.01852 -7762 4 46.7193 37.7552 17.0318 -13.8218 15.7663 -8.05182 -7763 4 46.1673 39.253 16.8241 -2.73609 -24.364 -6.22008 -7764 6 4.62701 28.4898 21.3631 -35.4199 -38.8764 -1.71187 -7765 4 5.05003 28.7578 22.1614 14.3175 13.903 20.3467 -7766 4 4.23296 27.6059 21.6238 11.0236 23.568 -16.8729 -7767 6 20.5692 15.1618 18.3974 -2.72234 -3.16682 18.7699 -7768 4 20.0205 15.9086 18.1633 -0.374776 9.93651 -8.10169 -7769 4 20.1114 14.8073 19.1799 7.71486 -3.14336 -3.02048 -7770 6 16.2446 13.6415 17.4737 -35.4034 4.06645 -23.9936 -7771 4 16.1835 14.6144 17.5029 6.20848 -12.1 -0.082548 -7772 4 15.5556 13.4035 16.7727 24.4056 2.85778 27.0666 -7773 6 52.5084 30.9566 18.1567 -0.97573 -12.5044 17.346 -7774 4 52.0533 31.4717 17.4985 -6.50351 10.4198 -16.9401 -7775 4 51.7821 30.6074 18.6971 11.4062 2.54252 -4.46582 -7776 6 24.418 1.73203 15.7939 2.07222 -10.1482 7.47229 -7777 4 24.2447 1.14878 16.5739 0.390494 16.7143 -9.44633 -7778 4 24.1366 2.64887 15.952 -0.929678 -6.23215 5.34629 -7779 6 23.8719 5.08832 31.0744 22.7283 -21.9769 -16.2257 -7780 4 23.8146 5.92648 31.5054 -7.3092 22.9653 9.22328 -7781 4 24.8319 4.92382 30.9303 -16.6577 0.531409 1.66203 -7782 6 29.6615 30.9343 0.410524 16.5859 -5.2272 -6.83283 -7783 4 30.4171 30.5602 -0.0763344 -8.98044 0.909776 12.9407 -7784 4 29.1293 31.2514 41.5907 -13.3941 8.54792 -1.14443 -7785 6 32.8591 37.9003 22.5268 -10.9299 -3.56267 -2.34485 -7786 4 33.7082 38.1164 22.1304 5.81458 1.66065 7.83892 -7787 4 32.835 38.1832 23.4516 6.53001 6.08896 0.386172 -7788 6 16.4762 17.3653 33.758 -11.7596 5.685 -6.41316 -7789 4 15.9639 18.0545 33.2621 15.6067 -10.6469 10.7903 -7790 4 17.1589 17.009 33.1621 -6.01342 7.59956 -1.04496 -7791 6 9.22918 13.3839 27.5418 -13.213 -9.30661 16.5651 -7792 4 8.30942 13.5198 27.2923 -4.71042 4.84624 -13.6557 -7793 4 9.0972 13.1179 28.4658 14.0632 -0.809421 3.61995 -7794 6 43.4685 7.73978 17.2176 -8.6426 5.21856 8.44668 -7795 4 43.4054 7.77113 18.1985 3.14312 -1.73226 -22.4674 -7796 4 44.4071 7.82788 17.0033 -0.931382 -0.0897333 1.197 -7797 6 22.3132 24.3412 23.1703 -9.75348 13.1727 -0.0757149 -7798 4 22.7871 23.5122 23.2675 1.8966 -9.89464 -1.11237 -7799 4 21.5045 24.1854 22.6454 4.5924 -1.52242 4.18414 -7800 6 26.0037 32.9236 32.716 -4.33416 -0.788049 -7.61174 -7801 4 26.2455 32.6516 31.8136 -0.0498336 0.850388 -0.133699 -7802 4 25.1949 32.4304 32.9126 -0.360701 -0.787143 2.76329 -7803 6 16.9426 19.041 7.45715 -3.10994 24.472 -2.41526 -7804 4 16.308 19.3093 8.14456 3.13816 -6.91205 -2.30089 -7805 4 17.0114 19.8381 6.87129 1.57938 -24.3813 10.2947 -7806 6 48.1131 14.4569 27.5699 7.08917 8.35207 6.49885 -7807 4 48.0603 15.1245 26.8691 -1.5138 -4.18476 1.16992 -7808 4 48.1537 14.9494 28.4126 -1.96213 -3.76556 -9.73571 -7809 6 52.3834 41.7541 11.1123 -0.447482 12.3 22.2377 -7810 4 52.3153 0.228199 10.2442 -0.817032 7.00513 -16.5207 -7811 4 52.6623 0.571857 11.7011 -4.41087 -5.87968 -8.23494 -7812 6 36.3325 6.93202 12.7048 -8.66608 5.7588 -1.53482 -7813 4 36.3873 7.88419 12.9074 5.41886 -9.49824 0.0534512 -7814 4 37.2464 6.6206 12.6662 3.93968 -0.5832 -0.272047 -7815 6 8.24609 20.3242 16.6676 2.28714 -8.73249 -3.11806 -7816 4 7.99607 19.3797 16.5602 0.915774 9.85224 4.30221 -7817 4 9.21956 20.3717 16.6442 -3.81833 -2.78155 -1.09608 -7818 6 28.8059 40.3215 12.8316 -6.32157 -2.99739 9.80695 -7819 4 29.5356 40.2333 12.2314 15.0973 -2.52646 -11.1155 -7820 4 28.4555 39.4209 12.8947 -4.4969 5.39171 3.74805 -7821 6 18.1648 11.8204 16.9538 6.42365 10.4423 10.6103 -7822 4 17.6537 12.6149 17.1793 -7.21931 -10.1359 -1.31065 -7823 4 19.063 12.1656 16.925 9.05203 -3.86377 -1.18548 -7824 6 30.8803 17.4233 21.4874 -38.9186 -21.5127 -11.6054 -7825 4 30.1793 16.7188 21.4067 15.4039 25.3522 4.50617 -7826 4 31.5864 16.9116 21.8642 20.5617 -1.86838 10.7411 -7827 6 34.8073 19.4112 37.959 10.4013 19.2527 -16.7989 -7828 4 34.9062 20.1671 37.3279 -0.177011 -16.5385 16.965 -7829 4 34.2544 18.768 37.5084 -3.31564 -7.45818 -3.12702 -7830 6 35.8251 16.8879 29.2053 19.9429 8.12055 25.1888 -7831 4 36.604 16.4922 29.6427 -6.21008 5.15879 -2.88988 -7832 4 35.5164 16.1914 28.6524 -12.7517 -21.289 -18.0185 -7833 6 3.03682 32.2806 6.33235 -9.22618 28.6071 10.2197 -7834 4 2.10307 32.1357 6.11945 6.4331 -12.4482 -1.5948 -7835 4 3.56193 31.5065 6.1559 2.8275 -21.5224 -7.32445 -7836 6 26.8 41.6522 10.1614 16.4152 -10.6242 6.62789 -7837 4 27.6763 41.4103 9.75871 -19.2491 6.11251 13.5217 -7838 4 26.9685 0.0827479 11.0562 4.26354 0.263175 -7.76775 -7839 6 52.2755 24.564 24.8743 -17.4742 4.09161 11.4913 -7840 4 51.3068 24.6875 24.9545 12.6777 -6.48001 -7.54331 -7841 4 52.5704 24.9086 25.7267 7.88636 1.59704 3.61539 -7842 6 22.6859 22.6471 33.5865 3.00815 -0.389016 -3.70522 -7843 4 23.2377 23.2516 34.129 -18.2936 -9.34398 -1.8364 -7844 4 21.8798 22.3666 34.0572 9.18357 8.33181 5.74035 -7845 6 10.6559 14.2334 33.0439 8.40108 -6.88321 -2.71679 -7846 4 10.5166 14.9368 32.4181 8.42324 10.9453 -12.1325 -7847 4 9.76709 14.0756 33.3137 -17.8131 -11.8211 11.2552 -7848 6 21.913 10.8504 11.5417 10.0273 5.1408 -10.1307 -7849 4 22.8643 10.6911 11.6864 -4.5907 0.219491 7.97275 -7850 4 21.4519 10.7503 12.3817 3.5408 -3.26695 13.1151 -7851 6 38.3604 6.02409 25.8423 -7.72295 28.2176 13.9057 -7852 4 38.0159 6.28095 26.7202 2.23326 -16.155 -4.56644 -7853 4 38.4362 6.90267 25.4438 5.48615 -7.56939 -11.5178 -7854 6 30.9465 26.6393 38.5732 9.04128 -30.5088 -25.1958 -7855 4 30.9128 26.4505 39.498 -1.67119 3.99535 28.8865 -7856 4 31.0441 25.726 38.2186 -4.36445 16.9712 0.749916 -7857 6 30.1667 14.6301 35.4838 10.1392 5.1159 -4.4805 -7858 4 30.5216 15.3681 34.9096 -25.1579 -14.4294 10.0398 -7859 4 29.1929 14.5877 35.5299 11.6839 11.6021 -8.75286 -7860 6 12.5351 37.2243 16.9695 -17.9994 -5.54058 0.759354 -7861 4 12.9667 37.9067 17.4519 9.84296 27.0859 15.3185 -7862 4 13.2146 36.5653 16.9126 10.1753 -19.489 -6.1469 -7863 6 27.4306 21.5582 37.7184 0.323044 -0.91237 -2.80926 -7864 4 26.8919 21.7087 36.9418 -1.95891 -4.49412 -14.6911 -7865 4 26.9535 22.0297 38.3943 0.198826 4.23191 11.3586 -7866 6 29.6082 18.3788 12.6829 -3.7237 -11.7076 25.6006 -7867 4 29.4829 18.1024 13.618 2.9495 3.49705 -16.1413 -7868 4 28.7034 18.5321 12.3984 -4.77545 3.00323 -3.28229 -7869 6 2.3585 15.6468 0.175999 -8.20612 37.5639 57.3692 -7870 4 1.52386 15.5898 41.6501 -20.1916 -9.73007 -21.8008 -7871 4 3.00191 15.1099 41.6903 28.5072 -35.3577 -30.6151 -7872 6 17.8194 25.7234 4.22068 -18.7286 -4.35761 2.03057 -7873 4 16.8619 25.5897 3.93795 36.6055 5.10926 -2.3659 -7874 4 18.4291 25.8425 3.4621 -13.2431 -0.0346718 7.72723 -7875 6 41.7912 11.1794 20.2704 -4.7703 -4.22644 -3.97484 -7876 4 42.5222 11.2179 19.6258 -6.77094 -1.14571 2.2342 -7877 4 40.9861 11.4636 19.8126 1.73275 2.14556 -1.92771 -7878 6 38.0378 18.3863 24.0278 -3.74133 -10.331 -0.132081 -7879 4 38.4309 19.0888 24.5482 3.22643 8.24914 5.57345 -7880 4 37.9308 18.7305 23.1431 0.767244 4.53126 -6.25669 -7881 6 4.13298 13.9173 33.7521 30.6843 -35.3272 -10.2657 -7882 4 3.2388 13.7394 34.0326 -6.45696 -6.01886 0.999898 -7883 4 4.62487 13.0231 33.6052 -30.6419 39.0128 7.66426 -7884 6 19.1936 19.1847 26.5022 -1.72621 -3.50471 2.07629 -7885 4 19.5259 20.0399 26.2155 5.41694 7.89262 1.74938 -7886 4 18.9505 18.7515 25.6854 -0.500338 -7.01675 -4.74744 -7887 6 22.475 26.1945 25.3345 -21.4458 -23.9003 -3.16659 -7888 4 22.3709 25.4906 24.6814 -7.32491 -4.57374 0.352876 -7889 4 23.3013 26.5414 25.0733 33.537 19.6696 -4.44151 -7890 6 48.8098 32.073 32.5556 -12.1052 4.48194 -0.190297 -7891 4 48.9381 31.1381 32.4233 -5.03309 -16.3747 0.495313 -7892 4 49.6354 32.4434 32.2762 12.9514 12.9364 -2.07298 -7893 6 25.2177 18.014 27.013 4.13139 4.11129 3.02633 -7894 4 24.4991 17.5573 27.49 6.6231 -0.568789 -7.074 -7895 4 25.6482 17.4406 26.3525 -8.92874 -1.57445 7.95973 -7896 6 1.76475 41.5608 24.9549 2.89162 -9.06076 -21.1384 -7897 4 1.88611 40.794 24.3317 -1.07403 19.5272 24.3581 -7898 4 1.30092 0.287142 24.3881 5.67761 -7.93757 11.1942 -7899 6 18.6633 11.7702 10.8608 -14.1102 -15.1967 11.3789 -7900 4 19.5021 11.9001 10.4051 -2.67857 -1.17934 -0.0567829 -7901 4 18.6465 10.841 11.1975 0.382459 20.6246 -9.54243 -7902 6 45.6242 16.5573 4.85031 17.0541 -2.39304 -3.72853 -7903 4 46.5701 16.2411 4.85652 -23.9929 13.0597 -1.64852 -7904 4 45.6057 17.5078 4.58964 5.38323 -15.7737 4.77093 -7905 6 40.6798 36.3894 24.0177 5.99482 15.2006 -18.5281 -7906 4 40.7505 36.8152 23.1136 -3.68852 -16.1642 25.9152 -7907 4 40.7388 35.4259 23.9735 0.360603 0.79119 -4.57544 -7908 6 32.2161 36.322 4.9431 5.19197 18.2152 11.0878 -7909 4 31.5074 36.1415 4.30154 10.9387 -10.0795 -6.57323 -7910 4 33.0257 35.7839 4.88769 -13.0089 -6.05715 -7.93038 -7911 6 1.60369 14.6754 10.8168 -10.3056 7.30247 33.6992 -7912 4 2.33423 15.3134 10.9307 -7.1595 -6.86026 -1.25923 -7913 4 1.1476 14.6845 11.711 13.0511 -0.847163 -26.6328 -7914 6 35.0153 14.2871 28.0739 18.7596 2.69464 30.5166 -7915 4 34.8734 14.0618 29.0187 14.279 3.49385 -12.2543 -7916 4 34.1456 14.1907 27.7398 -26.4062 -1.19123 -20.5956 -7917 6 54.7157 6.11907 21.8609 -12.1949 -7.16094 1.89291 -7918 4 53.7846 6.03827 22.1577 10.7478 1.95047 -3.13077 -7919 4 0.0370646 6.90146 22.3147 2.89466 7.98076 3.79048 -7920 6 31.7642 16.9274 27.3665 -7.54316 -5.52924 6.90942 -7921 4 30.8348 17.1206 27.2023 -9.34166 0.83246 -0.0222557 -7922 4 32.1928 17.2544 26.5838 13.9998 7.82105 -16.2222 -7923 6 14.4504 28.0052 11.1087 -4.71237 -14.6735 4.6077 -7924 4 14.1081 28.8557 11.3451 -9.65694 14.7183 8.34222 -7925 4 14.826 28.1745 10.2406 5.25389 -7.26775 -5.19981 -7926 6 35.6627 19.4906 18.309 1.38743 3.66357 1.00844 -7927 4 36.0608 19.4502 19.1905 -8.3289 1.62604 -1.04031 -7928 4 34.971 18.8114 18.299 7.41978 2.58016 -0.85803 -7929 6 0.908295 12.7232 15.4509 -10.2874 -45.1283 5.64528 -7930 4 0.635795 11.7526 15.3361 10.0925 35.0181 2.47128 -7931 4 1.39513 12.719 16.2997 -3.76012 1.73199 -7.91518 -7932 6 52.7239 14.8052 20.9911 -10.1838 -50.8962 13.8805 -7933 4 52.1355 13.9729 20.9263 20.4043 37.1153 -0.0771148 -7934 4 52.3678 15.481 20.4204 -9.75671 2.85516 -9.21068 -7935 6 7.50014 6.78453 13.6112 45.6118 -3.77462 -0.237279 -7936 4 7.66407 7.72531 13.7166 -11.095 5.64184 -2.33744 -7937 4 8.44113 6.46934 13.5548 -33.3093 -4.56257 -1.46213 -7938 6 12.8693 29.1327 30.951 -35.1999 43.7452 -37.9705 -7939 4 12.911 28.5157 30.2274 6.73286 -14.9776 0.757022 -7940 4 13.2432 28.8129 31.7306 26.8069 -31.1286 39.1504 -7941 6 8.91269 29.9946 35.6682 4.82638 -20.5676 13.9142 -7942 4 9.08199 29.9869 36.6487 -3.4848 12.9743 -23.6701 -7943 4 8.85763 30.8835 35.2999 2.4913 8.97671 5.8399 -7944 6 29.2501 7.21193 5.56384 -35.3124 23.3999 -5.45769 -7945 4 29.8929 6.567 5.7677 24.3163 -25.3556 4.38867 -7946 4 28.4878 7.00912 6.14468 16.2636 8.35776 -7.44031 -7947 6 25.8882 9.2493 3.85609 -10.1418 -10.3657 2.14015 -7948 4 26.6938 8.77544 3.58522 -5.62061 -1.52714 -0.987441 -7949 4 25.143 8.71761 3.5088 14.4855 4.13341 2.07026 -7950 6 46.1828 19.5303 23.8452 27.5142 -8.79556 18.2338 -7951 4 47.0303 19.3932 24.4147 -29.6641 11.3761 -34.952 -7952 4 46.4302 19.9015 22.9687 10.0609 -5.49214 13.8961 -7953 6 18.6 35.3226 28.7813 33.9262 -21.2248 5.29661 -7954 4 18.5078 36.1255 28.2543 2.15121 5.76995 -5.3877 -7955 4 19.5645 35.0126 28.755 -37.0827 17.274 -2.06568 -7956 6 28.0068 22.625 32.1882 17.1638 -9.71048 -11.652 -7957 4 28.1161 23.0799 31.3381 -0.933036 0.686599 6.01892 -7958 4 27.1717 22.9224 32.5558 0.319614 0.839726 2.26602 -7959 6 25.9992 18.4251 22.6716 -8.51512 -6.6596 14.3523 -7960 4 26.8098 18.8237 22.3895 20.3106 6.57833 -11.9809 -7961 4 25.8253 18.8771 23.5162 -1.041 -7.57666 -6.79729 -7962 6 31.1689 23.0872 29.1831 -2.26749 -18.4759 6.78914 -7963 4 31.118 22.1592 28.8841 -5.05583 5.59361 3.05947 -7964 4 31.7418 23.5345 28.5581 5.1573 7.79625 -4.49352 -7965 6 36.6391 4.9259 0.480345 37.9344 10.2065 -26.5572 -7966 4 36.638 5.82198 0.886244 0.658013 -14.6584 -5.92388 -7967 4 37.39 4.95173 41.699 -35.1456 1.42767 30.4358 -7968 6 36.484 21.0145 10.0529 -6.00883 6.48187 8.17175 -7969 4 36.4042 20.1763 9.58301 3.63574 2.58382 -3.15576 -7970 4 35.8773 20.9259 10.8015 2.14778 4.06152 -0.936887 -7971 6 50.5993 25.1947 18.3919 -28.2028 12.9956 8.35013 -7972 4 49.869 24.7394 17.9262 9.19638 1.46827 3.55355 -7973 4 51.4482 24.8993 18.0848 11.0575 -8.08323 -5.33222 -7974 6 50.1824 39.6576 12.4356 -22.7811 -7.9912 15.1349 -7975 4 49.7705 38.7879 12.6194 4.75387 11.043 -2.88475 -7976 4 51.0686 39.4751 12.1603 15.8621 -1.53988 -6.37666 -7977 6 30.5412 12.4178 4.80566 -15.3128 -2.78075 25.3711 -7978 4 30.0752 11.5776 5.01806 10.6669 11.6172 -5.90727 -7979 4 31.021 12.2424 4.01172 11.531 -8.83371 -18.4272 -7980 6 28.9525 15.4713 21.8679 -2.36978 -36.4192 26.6063 -7981 4 29.1677 14.6271 22.3934 -7.66269 33.2693 -19.6276 -7982 4 28.1632 15.8063 22.3348 7.54721 -2.84859 -11.2752 -7983 6 14.0684 9.5583 16.997 2.7235 -6.59901 -0.744295 -7984 4 14.8185 8.94582 17.0717 -0.0957791 5.7783 -3.11218 -7985 4 14.4323 10.4488 16.9992 1.00571 2.57913 -1.39277 -7986 6 4.48903 30.1743 11.858 18.777 -10.7052 13.2768 -7987 4 4.86699 29.7697 12.6847 -17.3276 7.96894 -17.1216 -7988 4 3.53137 30.2861 11.9207 -0.113543 -0.314347 4.01346 -7989 6 40.8874 8.0652 23.6541 0.993335 -18.0149 -24.6412 -7990 4 41.0014 8.23968 22.6934 -0.45004 7.6784 15.1082 -7991 4 40.7726 7.0925 23.6399 1.20374 9.92563 8.58777 -7992 6 53.7462 35.0557 16.7061 9.98011 -4.48961 -22.2856 -7993 4 53.4827 35.8182 17.2307 0.000554802 6.10184 -1.96461 -7994 4 54.0786 35.3449 15.8213 -7.68991 -0.599931 23.4559 -7995 6 53.7073 10.1889 20.3718 -10.7517 16.2467 -19.4493 -7996 4 53.8408 10.0262 19.4272 8.41512 -10.415 5.03553 -7997 4 53.1338 10.9644 20.2967 0.731263 1.06205 11.7435 -7998 6 4.58979 27.075 7.78807 17.6653 -15.6715 -1.75621 -7999 4 5.19096 26.32 7.80399 16.3727 7.79792 -3.24405 -8000 4 3.78382 26.6199 7.94519 -28.415 1.42755 3.38346 -8001 6 50.5066 22.5306 22.1436 -1.2339 18.6921 5.41009 -8002 4 50.2802 23.3104 22.6632 -2.8343 -11.09 7.6214 -8003 4 50.7991 22.9414 21.3369 4.56213 -7.53044 -15.8119 -8004 6 7.04346 27.196 21.628 9.41144 -9.96736 11.8657 -8005 4 6.8407 26.6883 22.4668 -8.25713 16.2835 -27.3312 -8006 4 6.26031 27.4748 21.116 4.26862 -9.43237 15.0117 -8007 6 23.8265 35.0499 16.5937 18.3012 9.13896 26.4348 -8008 4 24.7235 34.8381 16.9269 -14.9485 7.62278 -2.13189 -8009 4 23.7604 34.5968 15.7714 -3.77201 -11.7597 -22.7393 -8010 6 5.98953 23.8983 3.91761 -44.4181 -14.5448 -1.98234 -8011 4 5.398 23.9519 3.1318 15.794 0.401012 8.45254 -8012 4 5.35617 23.6012 4.61938 19.6174 4.72778 -5.04958 -8013 6 38.7401 25.0729 19.1247 8.8169 4.91643 10.7802 -8014 4 38.7862 24.2921 18.5681 -1.99613 -8.272 -9.94687 -8015 4 39.0639 24.8191 20.0061 -2.94522 4.87881 -4.09917 -8016 6 12.9717 18.2893 10.6182 7.92512 -8.05782 -7.58833 -8017 4 12.0999 18.3162 10.2013 -2.76008 2.25331 1.21984 -8018 4 12.8722 18.6085 11.5165 -3.68712 5.29275 10.5515 -8019 6 38.0382 41.2423 21.0873 4.88219 -19.6272 -0.152698 -8020 4 37.2014 40.7765 21.2484 2.63704 8.02432 -2.02816 -8021 4 37.8835 0.198079 20.7163 -11.2369 15.8096 -5.69312 -8022 6 6.98214 22.8682 17.8394 -5.75247 -17.9204 -1.57462 -8023 4 7.61723 23.542 17.6412 15.6839 20.0065 -5.16874 -8024 4 7.3587 22.0484 17.4826 -2.13646 0.815835 3.23256 -8025 6 24.1186 19.368 12.3177 21.0449 6.23804 -24.2445 -8026 4 23.9242 19.844 13.1293 -4.19124 -3.15082 3.8784 -8027 4 23.743 18.4928 12.3308 -10.9397 -14.908 7.07664 -8028 6 44.2213 28.4415 4.8153 2.12167 -7.44997 -5.8313 -8029 4 44.3009 28.0649 3.91739 -1.37383 9.18016 5.99771 -8030 4 44.2294 29.4128 4.74855 1.01191 -3.53144 -7.03239 -8031 6 23.3167 8.29314 21.4338 -0.329791 14.7993 14.6131 -8032 4 22.995 9.23581 21.5362 7.25813 -26.2111 -7.67418 -8033 4 23.1349 8.01865 20.5229 -2.36131 4.58949 1.23489 -8034 6 14.3464 2.19127 18.5365 1.00479 -5.05512 -1.33996 -8035 4 14.3534 1.26337 18.7781 -10.0191 -8.45544 9.17935 -8036 4 15.2531 2.29149 18.2562 13.6881 11.5937 -7.27189 -8037 6 28.0536 31.92 34.134 3.57463 -14.0429 -1.6048 -8038 4 28.4517 32.4188 34.8607 -2.66641 5.35559 -0.0232853 -8039 4 27.3246 32.4577 33.7701 8.655 -3.68096 2.2403 -8040 6 53.3502 24.7032 18.2649 -24.2711 -41.2818 -9.83264 -8041 4 53.5194 24.6019 17.3193 6.96991 8.47211 -0.102973 -8042 4 53.68 25.5059 18.6169 17.7955 37.5084 3.34479 -8043 6 36.8031 28.4187 22.9511 -10.1554 -0.61119 21.2214 -8044 4 36.5106 28.9054 23.7358 4.15696 8.73481 -5.19311 -8045 4 36.1845 27.6911 23.0035 -2.36033 -17.8474 -9.79811 -8046 6 21.8885 30.5877 27.4793 -3.11585 8.28062 7.57241 -8047 4 22.2621 31.0993 28.2061 -3.96796 1.5816 4.48491 -8048 4 22.5937 30.5949 26.8475 10.2249 -8.24374 -18.6607 -8049 6 10.2833 3.28406 27.2289 -24.5304 -2.91212 14.6365 -8050 4 10.0443 2.76427 28.0065 14.6588 -5.9106 -2.57837 -8051 4 9.44832 3.75002 27.1066 2.80489 10.142 -13.305 -8052 6 37.7147 24.9939 29.6988 5.24245 -12.5023 -10.1121 -8053 4 38.3581 24.5533 29.0689 -23.3017 1.4918 23.5498 -8054 4 37.1779 24.3214 30.1874 12.7329 5.56421 -12.5271 -8055 6 9.13611 24.4367 14.4784 20.7258 8.96054 28.4908 -8056 4 9.04651 24.998 13.735 -5.03994 20.1658 -22.0876 -8057 4 8.726 23.6299 14.2398 -14.2121 -32.2206 -7.12291 -8058 6 52.7755 31.4643 7.39569 14.5412 -1.52098 0.484013 -8059 4 52.3413 32.1584 6.88884 0.00633314 4.2069 -4.47258 -8060 4 52.0605 30.9716 7.79316 -9.34275 -9.05133 5.36325 -8061 6 21.3287 5.44475 36.4975 17.176 -11.9485 -14.2877 -8062 4 20.7483 5.50715 37.2619 4.90115 -8.53405 7.77147 -8063 4 21.912 4.64524 36.5597 -18.1029 20.6035 4.94996 -8064 6 25.1768 37.2214 4.32574 4.31983 -25.8241 -7.35849 -8065 4 25.4326 36.64 3.57657 -1.88178 18.0132 5.09494 -8066 4 24.8685 36.5657 4.9694 -1.32139 10.7309 7.78615 -8067 6 33.9928 17.4475 18.2473 -28.4515 -0.0793518 28.5349 -8068 4 34.2921 17.0113 19.1053 -15.0281 13.9289 -20.2703 -8069 4 33.1064 17.9171 18.4165 33.1367 -21.5966 1.81969 -8070 6 37.9532 37.4932 25.2939 -37.7872 -15.4269 -20.4394 -8071 4 36.979 37.7096 25.1406 34.3292 -3.43428 9.43604 -8072 4 38.1084 36.7677 24.6487 1.47089 11.2608 10.0337 -8073 6 5.08061 4.87523 15.8431 -4.86231 -7.56388 -2.23136 -8074 4 5.78156 4.1744 15.8759 -9.54967 26.0091 2.46095 -8075 4 5.43258 5.75 16.0822 6.78608 -13.538 3.56789 -8076 6 14.1628 7.20449 7.78038 25.2379 -5.46067 -13.6381 -8077 4 13.5115 7.54153 8.36471 -22.6877 11.2017 23.85 -8078 4 13.6914 6.99143 6.96374 5.13235 0.836748 0.117842 -8079 6 24.9714 10.8522 38.0874 21.7543 24.8019 24.8971 -8080 4 25.3733 11.7327 37.9223 -2.75098 -14.513 10.3213 -8081 4 24.5811 10.6456 37.27 -22.0988 -18.3607 -37.1034 -8082 6 35.6792 7.98105 22.8098 -5.63995 -0.874411 -1.68631 -8083 4 36.3111 8.66137 23.0699 5.30437 2.23481 0.770305 -8084 4 35.3824 8.20038 21.9134 0.62108 2.61089 2.3422 -8085 6 24.7967 29.145 22.4166 8.97915 1.26062 2.6062 -8086 4 24.9285 28.4017 23.0307 -7.24415 3.31799 -2.87627 -8087 4 23.8684 29.1691 22.1667 -6.93063 -5.53381 0.128782 -8088 6 38.5003 31.6402 38.4666 0.118802 17.9484 -3.06973 -8089 4 38.5639 32.3894 37.8454 -0.598215 -11.959 -0.514206 -8090 4 38.3632 32.08 39.3134 -2.43734 -3.45212 12.1107 -8091 6 7.2246 33.2558 15.4144 3.93224 14.6297 14.7993 -8092 4 8.10558 33.3578 15.8508 -19.4169 -6.69939 -13.0108 -8093 4 7.30076 32.5035 14.7978 2.24681 10.3389 8.67702 -8094 6 43.3411 23.605 1.45378 1.24542 -6.52262 6.11498 -8095 4 43.1714 24.3501 0.858367 5.1295 -5.17404 3.37123 -8096 4 44.2208 23.7695 1.84296 -12.8059 2.13297 -8.4534 -8097 6 3.53981 32.9157 14.8686 -7.67856 -8.73615 6.98201 -8098 4 3.60397 33.2061 13.9566 0.668747 6.43783 -7.96574 -8099 4 3.81902 33.649 15.4236 5.03764 7.23473 -0.501009 -8100 6 25.308 21.7722 8.24708 3.37146 -12.406 14.7751 -8101 4 26.0573 21.1741 8.36562 1.41198 8.84323 -6.65363 -8102 4 24.826 21.6647 9.09095 -1.64121 7.89428 -12.8382 -8103 6 43.814 15.3562 17.763 -19.8802 -3.64728 -7.58039 -8104 4 43.4756 15.1225 16.8733 5.20247 0.973102 4.81929 -8105 4 44.7686 15.2775 17.7045 7.07231 -2.77487 -5.74422 -8106 6 15.7867 16.2594 16.6597 40.7179 11.0003 30.8626 -8107 4 16.4245 16.8568 16.2414 -0.344326 0.180624 1.74019 -8108 4 15.1074 16.2177 16.037 -41.8412 -2.72902 -33.087 -8109 6 31.9018 12.864 11.5221 -0.527288 11.9796 -2.61342 -8110 4 32.4715 13.19 12.2739 -15.261 0.218931 -18.2329 -8111 4 31.4408 13.5947 11.0331 13.5047 -10.6099 18.0399 -8112 6 18.2179 5.3463 10.1762 9.71532 5.2148 -18.3501 -8113 4 17.8204 5.66693 9.33813 -2.6575 -7.74782 15.1878 -8114 4 17.5556 5.18411 10.851 -9.29453 0.73034 -3.17809 -8115 6 23.0812 39.0781 10.9303 2.37609 8.25457 -4.90642 -8116 4 24.0025 38.8104 10.892 -1.10831 -0.594451 2.83356 -8117 4 23.078 39.9337 10.4697 -7.78026 -4.85412 5.47405 -8118 6 46.8678 33.747 8.76655 -5.11485 44.7451 24.4631 -8119 4 46.406 34.5339 8.40734 -0.304999 -21.98 -10.152 -8120 4 47.1603 34.1422 9.62028 2.09293 -20.2864 -11.5212 -8121 6 31.2447 39.9321 20.2226 -0.330123 -0.585472 -4.98228 -8122 4 30.8504 39.3151 19.5884 6.05804 4.05585 3.92388 -8123 4 32.2053 39.9316 20.0453 -4.95864 -1.44581 -1.12159 -8124 6 15.9016 33.0949 19.7876 25.1907 -5.52815 -22.1207 -8125 4 16.0748 33.7133 19.0349 -1.92202 -14.988 11.1016 -8126 4 16.5267 32.3265 19.6592 -15.8695 19.8556 5.2806 -8127 6 32.5654 39.9188 2.66304 17.6014 -10.2623 -15.3377 -8128 4 33.3417 39.59 3.14903 -11.9816 5.68487 0.865723 -8129 4 31.9971 40.348 3.29791 -5.42947 4.08066 9.69521 -8130 6 50.71 12.2088 3.91621 6.45352 -28.1924 -19.9843 -8131 4 51.4315 12.4725 3.33505 0.00989865 5.72461 1.55844 -8132 4 50.5782 12.8645 4.57223 -0.528152 29.464 22.8196 -8133 6 44.6954 2.75762 12.1022 0.941183 0.541095 5.21442 -8134 4 45.0772 1.91827 11.8337 7.97486 -4.13832 -5.1586 -8135 4 44.7961 2.76556 13.0748 -3.12194 1.26681 -13.8655 -8136 6 11.5119 11.9446 31.6555 0.0165034 5.87533 16.9496 -8137 4 11.2786 12.7291 32.193 1.1093 -4.42098 -1.85793 -8138 4 11.5615 11.2089 32.2952 3.49417 6.36211 -10.0029 -8139 6 4.75553 10.0442 10.5026 -0.613356 7.28818 -1.41717 -8140 4 5.04922 10.2458 11.3982 -0.190174 3.033 -2.19553 -8141 4 4.45357 10.8768 10.0827 4.22944 -8.29703 6.91569 -8142 6 17.1004 25.0221 20.585 20.8628 27.7333 -27.8469 -8143 4 16.2314 24.7196 20.7848 -24.892 -11.5638 6.73224 -8144 4 16.9745 25.5771 19.7683 4.93088 -15.3222 19.1034 -8145 6 48.1032 4.75801 14.8026 37.7024 -16.8658 7.41777 -8146 4 47.1817 4.923 14.9438 -21.3904 13.2232 -6.86149 -8147 4 48.4894 5.33532 14.1187 -17.354 1.23192 4.40994 -8148 6 18.8584 3.1094 3.41532 -17.9645 -5.092 -5.76247 -8149 4 18.4858 2.24853 3.65522 2.22195 0.198645 3.24183 -8150 4 19.7914 2.99202 3.55078 21.8001 -2.9136 1.99579 -8151 6 35.4214 26.4496 29.0479 -25.0869 -13.2406 8.30382 -8152 4 35.4596 27.2122 28.4766 3.66886 10.9927 -9.48044 -8153 4 36.2884 26.0622 29.0901 17.6032 -4.12101 -3.28535 -8154 6 32.3918 31.2203 12.8386 46.3164 14.9485 -1.56764 -8155 4 31.5927 31.2548 13.3118 -34.7781 -0.694705 18.2501 -8156 4 32.2274 30.836 11.9945 -8.46486 -12.2685 -25.2096 -8157 6 32.9972 28.3347 37.5978 -19.2694 -14.478 20.0019 -8158 4 32.1604 27.8545 37.87 25.9433 12.8245 -4.2723 -8159 4 33.4478 28.5699 38.4425 -10.0504 -3.89776 -17.7975 -8160 6 45.4943 24.785 10.3174 -24.9891 51.3938 13.5053 -8161 4 44.9436 25.3819 9.72852 18.6998 -28.2383 15.0369 -8162 4 45.6946 23.9769 9.88803 3.95472 -26.3164 -24.236 -8163 6 14.7646 31.7016 3.17106 -12.494 -4.77828 16.8956 -8164 4 14.1278 32.382 2.84257 8.55448 -13.727 9.9815 -8165 4 14.4774 31.2925 4.03575 0.781246 20.1514 -26.73 -8166 6 31.932 7.70259 4.29822 28.2629 -13.9597 32.9447 -8167 4 31.5142 6.8338 4.23667 -1.26054 0.464616 -4.26218 -8168 4 31.5893 8.26695 3.64018 -18.9284 22.0156 -31.588 -8169 6 42.5661 17.3076 32.2072 4.58091 20.9841 -12.8778 -8170 4 41.6153 17.2751 32.1225 -13.9289 -9.63208 0.974916 -8171 4 42.7549 18.1312 31.7017 7.23855 -15.1499 9.29454 -8172 6 13.801 23.1802 23.5544 20.5107 -9.18639 9.43365 -8173 4 13.5559 23.799 24.2431 -7.02941 8.57916 4.58982 -8174 4 14.6139 22.757 23.9348 -15.8084 7.21572 -12.2969 -8175 6 10.7224 7.09218 3.96878 16.2046 -14.1912 -58.7694 -8176 4 10.4615 7.01435 4.86228 -13.7845 -9.22242 34.898 -8177 4 10.4899 6.25858 3.45399 4.94204 24.1379 24.5516 -8178 6 28.7975 8.66057 17.8838 -26.4281 5.00156 -27.4828 -8179 4 29.5466 8.31163 17.3909 5.91048 -3.96826 -5.96201 -8180 4 28.1517 8.96764 17.1731 20.0585 -9.38402 22.2692 -8181 6 19.4445 29.3512 26.6402 -27.7559 12.8002 37.2849 -8182 4 18.9931 29.7086 27.4672 16.1765 -10.1498 -30.4371 -8183 4 20.3292 29.7071 26.6996 8.86807 3.45557 2.67965 -8184 6 40.676 40.9989 14.5783 -1.81287 -10.2023 17.4849 -8185 4 40.8703 41.6798 13.9303 10.8761 5.87921 -5.34291 -8186 4 41.4788 40.6754 15.0317 -0.103076 9.61372 -9.63617 -8187 6 46.2568 14.0853 31.7234 10.6503 -1.46249 4.93376 -8188 4 46.4506 13.1375 31.7184 -3.79774 3.42444 -0.601084 -8189 4 45.5065 14.2191 31.1522 -8.96365 0.976246 -7.34606 -8190 6 36.7103 36.3065 8.39844 -19.1971 -27.2559 -17.1971 -8191 4 36.3822 37.2167 8.51449 20.2374 -9.10083 14.9839 -8192 4 37.462 36.0245 8.9597 -8.83948 23.9771 2.75809 -8193 6 30.7983 32.4219 38.0908 -28.9564 1.76229 18.7871 -8194 4 31.3387 31.9445 37.476 23.2205 -2.83162 -11.1976 -8195 4 31.2894 33.1287 38.5298 9.85106 -3.61838 -6.87003 -8196 6 47.9 8.84746 10.1809 13.9026 13.2481 4.99334 -8197 4 47.2314 9.07534 9.54683 -14.9306 19.0332 -8.73943 -8198 4 48.008 7.93273 10.003 10.2061 -26.7512 4.08493 -8199 6 24.4282 17.0027 30.9766 -8.14946 0.47403 -13.61 -8200 4 23.7021 16.9118 30.3187 14.132 0.581257 9.28124 -8201 4 24.0019 17.1514 31.8341 1.66288 -1.35228 -5.87998 -8202 6 40.5039 5.09263 4.48513 -8.56504 -6.5373 -32.2613 -8203 4 41.2755 5.64065 4.37578 16.2932 9.35997 9.97847 -8204 4 40.1843 5.0523 3.55179 -2.89742 -7.45623 19.6864 -8205 6 52.5794 28.086 6.91602 -27.2154 -20.1235 6.97783 -8206 4 52.4353 28.6007 6.11552 3.94928 -0.112987 0.705634 -8207 4 51.6969 27.6552 7.08025 27.1089 14.7333 -4.60736 -8208 6 36.0629 32.381 23.6142 9.17579 -16.9148 -2.4755 -8209 4 36.5407 32.2813 22.7776 -1.15674 3.38979 7.41153 -8210 4 35.7113 33.2654 23.6252 -9.15386 11.2493 0.0331211 -8211 6 23.6552 31.8756 22.7565 -25.0136 1.00336 21.6204 -8212 4 23.73 32.5959 22.1297 15.1034 -2.64982 -11.1407 -8213 4 24.3343 31.2055 22.6866 12.2933 -0.39941 -10.0267 -8214 6 0.736598 24.4641 41.7072 -6.94393 1.55048 -19.4095 -8215 4 1.23654 24.8288 40.9522 -3.95743 -2.80997 9.51773 -8216 4 54.8325 24.2702 41.3637 13.4109 4.08216 3.5339 -8217 6 15.9721 8.97822 19.8125 19.0517 -22.613 16.6544 -8218 4 15.5497 8.29105 19.3091 -4.28185 -9.24838 -10.3339 -8219 4 15.6128 9.78815 19.5092 -16.7051 35.4763 -13.493 -8220 6 33.1656 12.5735 20.0353 32.8597 -32.3881 -24.7893 -8221 4 32.9817 11.6196 19.8453 -6.04217 28.6875 8.28399 -8222 4 34.1172 12.6638 19.7368 -32.1809 10.6792 11.3696 -8223 6 7.04894 24.9401 26.3957 -12.3425 -2.00741 -5.21086 -8224 4 6.75821 24.2907 27.0478 8.01299 -1.99342 6.24335 -8225 4 7.89161 25.3154 26.6505 10.7219 -3.29246 12.7441 -8226 6 44.479 22.5508 36.9163 -6.8399 -5.44184 13.3083 -8227 4 43.5214 22.4098 37.071 12.5044 3.3732 -3.51472 -8228 4 44.595 22.7899 36.0028 -4.86816 3.42784 -13.6235 -8229 6 39.2745 23.7032 25.1197 -32.3737 -81.7274 9.17932 -8230 4 39.5886 24.5492 24.9992 24.471 68.8814 -13.2187 -8231 4 38.7456 23.4691 24.3377 5.22396 6.33701 6.85867 -8232 6 20.3646 2.19602 36.9892 -4.85825 6.83938 3.69158 -8233 4 20.3067 1.45038 37.5971 1.4243 -8.23943 -2.36696 -8234 4 20.3942 1.88275 36.0861 3.42557 -6.35335 -2.19064 -8235 6 22.8664 19.5513 3.67104 -13.2265 5.28042 31.2857 -8236 4 22.7633 19.8561 4.6286 7.01101 -9.22167 -32.7463 -8237 4 23.7764 19.7315 3.39612 4.00916 2.85623 5.02623 -8238 6 31.705 12.5768 34.6039 18.8969 7.7197 42.0834 -8239 4 31.1026 13.3107 34.9476 21.2302 -23.3848 -5.30166 -8240 4 32.3569 12.3026 35.3493 -33.8624 17.1964 -33.567 -8241 6 12.9851 10.2105 25.0956 -25.1193 26.0078 -38.429 -8242 4 13.6149 10.0452 25.7619 22.39 -15.9831 32.7066 -8243 4 12.4963 9.40655 24.9468 1.34194 -14.9569 1.62555 -8244 6 27.2621 0.584423 13.2176 -28.6404 -16.2485 2.71576 -8245 4 27.7069 41.6292 13.1518 2.13728 8.59646 -2.51953 -8246 4 26.2847 0.395264 13.1771 23.0038 6.72582 -0.601928 -8247 6 5.66006 24.9398 13.9833 -7.43295 9.91556 10.5591 -8248 4 4.70147 24.9177 13.9802 -4.26929 -7.73667 -8.07402 -8249 4 5.82197 25.381 14.8221 8.41297 -1.15026 -0.763214 -8250 6 22.9908 17.9523 0.521723 7.02411 -25.4698 12.909 -8251 4 22.4592 18.6506 0.142784 -9.22706 3.46645 -2.83539 -8252 4 22.3527 17.3052 0.930771 13.2695 22.3169 -13.3733 -8253 6 33.0935 25.4243 5.46557 -9.38497 -10.8046 -8.60877 -8254 4 33.4966 26.2756 5.44764 14.9521 17.8538 5.01915 -8255 4 32.9941 25.2035 4.5344 -2.6207 -6.96629 2.5324 -8256 6 8.53079 7.95552 17.4804 7.64086 6.41223 -26.4035 -8257 4 9.4001 8.35547 17.2638 -9.73917 -4.33322 7.64386 -8258 4 8.4487 7.94255 18.4286 4.30191 2.70426 16.6029 -8259 6 26.8371 0.685906 2.89773 -0.256761 31.01 4.86999 -8260 4 26.7806 0.433187 3.83156 0.637082 -2.67537 2.60738 -8261 4 26.6279 1.66343 2.89109 6.9325 -26.481 -2.08778 -8262 6 50.0417 34.7142 15.6334 -23.0288 8.72534 -30.9996 -8263 4 50.5531 35.2159 14.9759 6.02412 -4.51102 12.1494 -8264 4 49.1615 34.6714 15.1751 14.0914 -5.62478 19.352 -8265 6 46.2791 4.99946 11.1196 9.7179 12.4772 -7.72995 -8266 4 45.7827 4.25534 11.4529 -10.6417 -11.5364 6.26713 -8267 4 46.9456 4.6214 10.5389 1.00953 -4.68959 -1.2994 -8268 6 33.7936 38.6123 35.3918 15.2762 25.882 47.4359 -8269 4 34.0305 39.0866 36.2411 -6.18084 -28.1229 -24.2145 -8270 4 33.6134 39.3784 34.8506 -5.42867 -1.33428 -20.4371 -8271 6 30.8282 25.8371 41.2172 -7.09757 -19.9215 -22.3179 -8272 4 31.1427 24.9253 41.375 1.19635 8.28989 4.89631 -8273 4 31.1138 26.3841 0.0263053 10.2845 10.2166 22.0109 -8274 6 50.2275 0.982033 24.4751 51.8832 -7.79127 14.7425 -8275 4 49.5671 0.561213 23.9746 -37.5145 -10.5742 -20.1648 -8276 4 51.0349 0.46072 24.2534 -17.6876 18.8276 11.0022 -8277 6 31.2908 0.710797 19.047 -2.09434 13.573 -1.22083 -8278 4 30.4487 0.672221 18.611 -14.5784 9.11804 -11.7691 -8279 4 31.2841 41.7946 19.4765 8.98672 -35.4229 20.9418 -8280 6 39.0741 29.5515 19.1276 -25.3595 -21.9961 15.137 -8281 4 38.1807 29.4949 19.565 25.109 7.94863 -12.7917 -8282 4 39.4837 28.6866 19.3452 2.49072 15.8212 -6.56848 -8283 6 21.6546 17.5955 25.8962 -6.78298 15.7545 0.118362 -8284 4 22.0482 18.4938 26.0891 -15.3421 -24.4294 -5.96834 -8285 4 20.8112 17.7106 25.4012 18.8301 2.25602 6.45745 -8286 6 35.0761 28.7988 27.4227 3.11164 -5.22767 30.3338 -8287 4 35.4099 29.4705 28.0422 -1.31539 -7.25274 0.820077 -8288 4 35.176 29.229 26.5925 2.58985 10.308 -31.8228 -8289 6 30.7102 25.4463 11.6589 -5.09223 14.513 32.8165 -8290 4 30.6059 25.8179 12.6014 3.72506 -14.6402 -39.0718 -8291 4 30.6061 26.1982 11.055 2.14208 -0.820709 7.44645 -8292 6 7.34821 15.124 12.3469 -7.98455 -28.7648 8.02815 -8293 4 6.65824 14.4547 12.1585 7.38491 7.52419 4.72727 -8294 4 7.19665 15.7511 11.658 -2.78105 24.4343 -15.0907 -8295 6 16.8417 26.815 7.05419 -24.774 6.28148 -21.5195 -8296 4 17.6138 26.5995 7.5418 30.7131 -10.23 16.3776 -8297 4 17.1302 26.9688 6.14022 -2.93816 -3.28182 4.8763 -8298 6 29.5112 33.0571 30.9901 -17.2684 21.8413 -16.809 -8299 4 28.6007 32.8494 30.6893 8.91061 -10.9491 6.08618 -8300 4 29.8939 32.355 31.5124 -6.62171 -19.0922 5.25725 -8301 6 14.1054 2.12143 30.9174 -7.90077 -11.4283 37.211 -8302 4 14.0041 2.00138 31.9209 0.0297695 4.78336 -39.0496 -8303 4 13.7376 1.30679 30.5176 6.48361 9.45743 4.44265 -8304 6 15.6593 22.2688 2.88796 -26.3773 12.8308 -8.6958 -8305 4 16.4059 21.7286 3.01985 35.1738 -16.1657 6.55343 -8306 4 15.0005 21.6175 2.62854 -10.183 2.33344 0.69621 -8307 6 23.7324 29.1178 40.9691 12.375 28.71 1.88761 -8308 4 23.2563 30.0016 40.9795 15.1309 -27.3218 0.73938 -8309 4 24.7153 29.2815 40.9372 -24.8849 -3.40565 0.339466 -8310 6 38.1289 14.1609 13.7163 11.3988 23.3452 4.961 -8311 4 37.6355 13.3641 13.8052 -15.0683 -25.2976 3.04519 -8312 4 38.877 13.9408 13.1592 7.07353 -0.711776 -7.39216 -8313 6 35.2564 26.5047 15.5196 1.21661 4.3606 12.6683 -8314 4 34.5556 26.4436 14.8616 -0.145442 -0.409522 -0.299569 -8315 4 34.9009 27.0522 16.256 4.1263 -8.75979 -17.8666 -8316 6 19.0944 34.7315 16.477 3.93496 0.874554 38.8769 -8317 4 19.5342 35.6013 16.5498 -2.87948 -9.96323 -9.99674 -8318 4 19.0181 34.4301 15.5899 3.71142 3.01681 -30.4069 -8319 6 18.1805 29.7449 35.7046 18.8444 17.1873 -3.97052 -8320 4 18.2235 30.6593 35.335 -4.4784 -20.2666 13.1463 -8321 4 19.056 29.5886 36.1261 -9.76671 1.23141 -6.47371 -8322 6 54.1188 22.2659 24.9096 4.78421 -24.6774 -19.3149 -8323 4 53.6441 21.8104 24.1769 10.121 5.11789 9.9801 -8324 4 53.5075 22.9378 25.1661 -14.3198 20.1313 5.7187 -8325 6 30.3323 10.3375 34.0061 7.35563 0.641124 -2.21855 -8326 4 29.5734 10.4043 34.5817 -14.4555 0.0376959 9.72957 -8327 4 30.8213 11.1653 34.1487 -3.17747 -4.67635 -0.590304 -8328 6 38.3211 33.8974 18.5888 -1.32754 -0.89807 -0.720993 -8329 4 38.9926 33.271 18.8539 2.22312 -19.1913 3.89796 -8330 4 38.8713 34.6655 18.5317 3.84957 24.8056 -1.31283 -8331 6 22.4809 14.1697 34.431 -22.1622 -5.27184 -37.8541 -8332 4 22.5433 13.5186 33.673 0.822047 20.8222 24.5167 -8333 4 23.1773 14.0067 35.0533 16.0768 -5.18569 10.3575 -8334 6 38.0141 0.622036 2.34694 9.03481 -5.1652 10.3599 -8335 4 37.7113 1.09641 3.1189 -18.3016 16.1314 2.00329 -8336 4 38.7028 0.120019 2.79986 6.1006 -11.8827 -16.4842 -8337 6 38.8847 41.1446 10.3004 16.8495 57.0142 -12.497 -8338 4 38.6453 0.212884 10.3117 6.47193 -33.8599 -1.337 -8339 4 38.2374 40.7573 10.8541 -26.8649 -17.5582 22.9746 -8340 6 53.4109 21.9211 38.9712 27.3607 0.0645619 -10.5759 -8341 4 53.0384 21.9801 38.0859 -10.7304 2.2749 -0.0111998 -8342 4 54.3668 22.0571 38.7395 -19.1981 -5.88632 12.9741 -8343 6 39.9872 12.7205 36.288 -8.06793 35.3321 20.4333 -8344 4 39.087 12.3834 36.3725 1.18883 -9.13664 -3.11406 -8345 4 40.4905 12.1818 35.7009 7.36107 -20.124 -19.0601 -8346 6 48.4463 17.2389 40.5967 -24.7278 4.81563 12.4078 -8347 4 47.5665 17.6971 40.4852 25.7833 -12.0744 1.257 -8348 4 48.3987 16.886 41.5134 6.10343 4.05346 -12.6042 -8349 6 32.0413 9.35688 40.0251 1.84943 -9.41379 10.5137 -8350 4 32.8011 9.3156 39.4233 -4.71533 -3.42986 0.347912 -8351 4 31.8082 8.43016 40.2864 3.98001 20.4877 -6.20043 -8352 6 31.7351 22.4909 6.36481 -11.9835 4.517 5.86255 -8353 4 31.4453 21.6589 6.79738 2.31245 15.2673 -2.59345 -8354 4 31.3521 23.2372 6.88711 4.39127 -22.2776 -7.77946 -8355 6 51.0252 2.58567 21.5888 12.0252 -3.79771 4.1956 -8356 4 51.3852 1.69652 21.8042 -1.91984 13.1306 -1.09782 -8357 4 51.7712 3.19849 21.4753 -6.25067 -9.48202 2.92476 -8358 6 13.6387 22.0486 12.1519 25.289 13.6281 9.24284 -8359 4 14.4553 22.4795 12.4841 -9.12946 -7.35477 -7.44936 -8360 4 12.9422 22.6971 12.3091 -5.69931 -0.254566 -0.690626 -8361 6 23.6098 24.0343 14.6404 -2.85842 21.3712 -30.1324 -8362 4 24.3054 24.4792 15.1401 1.72137 -5.65962 3.08819 -8363 4 23.5196 24.6041 13.8393 -4.42688 -17.9982 21.1692 -8364 6 9.32217 4.85318 31.2328 11.4746 -4.61869 -4.10735 -8365 4 8.43042 4.86168 30.8848 -9.06213 4.49291 -0.279243 -8366 4 9.25495 5.26013 32.106 -3.85952 -1.36 2.0258 -8367 6 16.6786 26.3118 18.041 -30.5179 5.83101 -14.1852 -8368 4 15.8205 26.6594 17.6987 9.23568 -14.6779 7.38956 -8369 4 17.2149 27.0871 17.9121 20.6972 11.6613 1.32787 -8370 6 5.1068 13.5155 11.5503 -9.62018 18.629 -29.2057 -8371 4 4.37741 13.3629 12.1623 -7.62379 -0.222526 0.540006 -8372 4 4.70689 13.979 10.7366 10.5209 -18.4088 37.9064 -8373 6 29.6181 23.6359 8.06142 -1.81854 7.21422 -1.70755 -8374 4 29.1888 23.4521 8.90141 0.206013 -3.23773 -0.0922606 -8375 4 29.4815 24.5976 7.98987 7.61073 -10.2969 -5.72522 -8376 6 0.801466 7.54671 27.8401 6.5354 -3.49578 -14.7683 -8377 4 0.895859 7.27352 28.7573 1.78004 -0.979843 7.25552 -8378 4 1.54585 8.15528 27.6648 -11.1939 -10.5496 5.25649 -8379 6 15.4336 9.77253 0.489553 0.922542 4.3707 -1.35473 -8380 4 16.0351 9.34865 41.7726 4.14277 -6.55565 2.56274 -8381 4 15.4857 9.31476 1.34042 4.74784 -1.15717 -0.337147 -8382 6 18.8008 0.0730809 34.105 -10.3773 -6.96418 -21.8764 -8383 4 18.5081 41.5423 33.2731 5.22569 12.9238 15.5106 -8384 4 18.5071 0.998566 34.0742 -2.68781 1.40869 -5.2752 -8385 6 18.7326 30.7673 29.1559 48.9948 -22.8293 28.8452 -8386 4 19.5421 30.7479 29.7792 -35.6741 -9.01286 -31.0748 -8387 4 18.496 31.6741 29.187 -17.0068 24.787 -0.45657 -8388 6 48.459 16.4997 36.139 1.45519 10.5028 1.01521 -8389 4 47.6111 16.9857 36.2164 10.4415 -5.87096 -2.55811 -8390 4 48.4968 16.1176 35.2432 -2.18798 4.21486 5.30298 -8391 6 43.8007 0.467658 29.2569 28.3678 -13.8677 -3.77703 -8392 4 42.8971 0.305725 29.4937 -25.3214 -1.14832 5.94808 -8393 4 44.2622 41.5592 29.5347 -3.4854 12.8866 -0.12306 -8394 6 16.7282 13.8764 21.3804 -5.85841 5.25102 8.86173 -8395 4 16.2274 14.7005 21.5266 6.94274 -6.60805 -7.01164 -8396 4 16.607 13.4327 22.2267 1.29648 -4.09529 1.45702 -8397 6 17.3848 13.434 26.2514 27.8708 0.579352 -19.8612 -8398 4 18.2073 13.6243 25.7048 -28.5107 -7.2193 21.7409 -8399 4 17.5944 12.6077 26.718 -2.1357 3.12496 0.608863 -8400 6 48.1647 10.2208 23.7049 7.80266 -18.7522 13.388 -8401 4 47.9825 10.5204 24.6118 -3.05612 1.76991 -8.97221 -8402 4 48.0139 10.9468 23.1026 -1.19683 7.34816 1.26356 -8403 6 28.2773 17.9142 17.8758 3.72989 18.9709 -15.182 -8404 4 29.0682 18.432 17.6259 -4.1904 -8.84834 4.2635 -8405 4 28.5441 17.0749 18.25 8.7895 -11.8779 5.35139 -8406 6 54.0848 38.1774 23.6862 8.79068 2.20397 4.23058 -8407 4 0.0366427 38.003 23.4974 -14.1536 0.885634 -1.20583 -8408 4 53.5245 37.5494 23.203 6.54807 -0.952262 -0.611804 -8409 6 8.48984 18.3998 11.4055 -13.462 -3.57414 27.789 -8410 4 7.65602 18.6961 11.043 -9.38292 3.75479 -0.915161 -8411 4 9.09748 18.5243 10.712 30.3826 3.02886 -30.4498 -8412 6 45.9441 12.8818 11.0222 -16.4049 1.91652 -6.40765 -8413 4 46.711 12.6299 10.4835 -7.54952 -0.564906 -6.57768 -8414 4 45.1235 12.7466 10.4771 21.7466 0.735613 7.10643 -8415 6 16.2215 8.79448 14.033 27.9098 -14.9816 6.01142 -8416 4 15.5522 9.3752 13.7952 -53.829 20.9905 -11.5495 -8417 4 16.9359 9.40542 13.9326 31.9466 3.3348 3.59486 -8418 6 42.7223 13.3863 21.3918 29.8224 16.7773 6.64199 -8419 4 41.9142 12.8874 21.2836 -9.67718 -3.29752 -8.9243 -8420 4 42.6271 14.312 21.0975 -16.0363 -11.184 0.152454 -8421 6 20.9977 40.4228 16.4707 19.2311 -21.9074 5.84064 -8422 4 20.7341 40.0536 17.3362 -0.495629 5.04161 -8.05599 -8423 4 21.8212 39.937 16.2081 -24.2166 11.8961 5.45251 -8424 6 45.6397 11.4296 32.9439 38.4109 -29.1814 -9.99274 -8425 4 46.3321 10.7493 33.2028 -28.4056 24.9384 -5.22126 -8426 4 45.113 11.6624 33.7013 -7.79747 1.97566 18.4384 -8427 6 26.9602 8.8599 24.2968 13.5915 2.79356 4.8338 -8428 4 27.3951 9.75608 24.2837 -6.20264 -27.5971 5.81865 -8429 4 27.4821 8.2415 24.8764 -5.62896 20.549 -11.158 -8430 6 18.9707 2.44141 29.3655 -2.01209 17.0873 0.653095 -8431 4 18.2519 2.38593 30.0124 -1.45633 -1.83702 1.76482 -8432 4 19.0982 3.39915 29.1871 -0.208097 -9.69202 4.76181 -8433 6 8.2396 29.1642 19.724 -7.67611 -9.48635 17.3168 -8434 4 8.16332 28.9052 20.6672 2.00381 4.74558 -18.2193 -8435 4 7.79264 28.4685 19.2154 1.97612 2.42161 3.19163 -8436 6 9.03293 34.3085 18.6392 -6.8245 -3.51508 -5.57673 -8437 4 8.73043 34.3576 19.5508 2.61936 3.47829 -5.40237 -8438 4 9.19173 35.2194 18.3614 3.83285 -0.179546 -0.301582 -8439 6 10.1806 11.9309 11.2378 5.33181 -8.21116 5.18339 -8440 4 10.4199 12.8404 10.9987 -8.38943 -3.43734 -3.26379 -8441 4 9.2213 11.8063 11.1618 4.16708 15.3888 -2.40164 -8442 6 35.7388 21.6853 36.1571 -21.2187 21.2566 3.59668 -8443 4 35.0074 22.3505 36.1843 15.9506 -16.0405 0.715421 -8444 4 36.3839 21.978 36.8321 -7.05156 -5.2756 -8.86951 -8445 6 17.0774 12.5078 36.39 -5.14261 15.8003 12.7424 -8446 4 17.3404 12.7479 37.2961 -4.35419 -1.09545 -7.6232 -8447 4 17.4977 11.6659 36.234 4.71638 -15.3379 -7.50181 -8448 6 37.1607 13.034 34.2837 0.889917 6.85814 -56.1323 -8449 4 36.6144 12.2451 34.135 3.16712 2.80772 8.73621 -8450 4 37.2953 13.1592 35.1962 -1.91867 -3.10361 40.6259 -8451 6 38.9747 29.5563 13.2253 1.18838 24.1885 -12.4362 -8452 4 38.8174 28.6959 12.8484 -2.87796 -16.626 0.178868 -8453 4 38.7606 29.548 14.1582 -0.666122 -3.30753 9.89159 -8454 6 0.17037 29.343 29.4884 -1.26324 3.91124 -27.2421 -8455 4 0.785297 28.6867 29.1327 1.78511 -2.78426 6.40223 -8456 4 54.9717 29.8735 28.6813 -2.47422 -4.8209 18.3172 -8457 6 15.9286 0.264913 12.7638 2.77369 8.97324 -0.606717 -8458 4 15.3998 0.564835 11.9867 -4.35739 -9.72902 15.1241 -8459 4 15.3918 41.7399 13.4663 -4.26125 7.58409 -15.055 -8460 6 3.98508 11.9472 8.79546 -10.0423 -23.9471 10.8905 -8461 4 4.30821 11.7435 7.92681 6.40121 -7.70989 -16.6116 -8462 4 3.96465 12.8834 8.77069 -2.75643 37.1798 9.03734 -8463 6 24.0517 23.6768 19.9772 9.9875 -0.396554 0.578582 -8464 4 23.5025 22.9354 19.7663 -8.47693 -16.0962 -5.40355 -8465 4 23.4442 24.2751 20.4024 2.14545 13.6845 6.88162 -8466 6 4.48152 2.30986 23.9923 -27.0109 23.4084 27.373 -8467 4 4.59263 2.40669 23.0716 9.73085 -3.6317 -36.525 -8468 4 3.6479 2.81506 24.1139 10.3345 -10.6947 10.8816 -8469 6 33.0856 27.6588 33.8383 -8.68317 -6.77689 0.893276 -8470 4 33.3543 28.5605 33.6822 -2.66039 14.7626 -6.22211 -8471 4 33.7694 27.2718 34.3804 4.93538 -5.90298 8.33006 -8472 6 11.4012 21.7076 6.08442 -20.9181 -7.28975 6.20623 -8473 4 12.3452 21.6439 6.06884 23.6791 -0.506282 -5.12853 -8474 4 11.1369 22.1078 5.25059 3.06155 -0.534748 -3.52863 -8475 6 37.2275 13.5312 23.6107 -13.7454 14.8127 9.96245 -8476 4 37.2011 14.0176 24.4689 -4.04457 -8.03454 -15.7104 -8477 4 38.0738 13.1109 23.5305 19.2281 -7.80113 -1.86698 -8478 6 5.00929 21.0475 33.3676 1.03993 27.0325 -33.9401 -8479 4 4.24931 21.2691 32.771 13.0002 -8.94008 10.7478 -8480 4 4.70945 20.492 34.0664 -10.4226 -16.4153 18.9759 -8481 6 18.2024 37.5737 26.9347 11.0126 -1.54132 -8.69207 -8482 4 17.8515 38.4557 27.1129 2.92195 -1.85995 -3.39903 -8483 4 18.9058 37.6892 26.2602 -8.80934 -3.84756 9.96821 -8484 6 19.7475 16.1502 4.67922 -0.59461 -5.69737 6.80756 -8485 4 18.938 15.9829 5.17999 -0.503733 6.42822 -3.53139 -8486 4 20.452 15.899 5.29485 1.51569 2.54074 -3.7554 -8487 6 54.0588 32.502 15.5791 2.11509 -30.3723 -27.0265 -8488 4 54.9193 32.2734 15.944 -2.03587 2.87368 2.60187 -8489 4 53.7148 33.1889 16.1175 -9.21817 24.1266 16.9863 -8490 6 31.1319 3.81908 36.7331 -8.52453 -12.3767 5.98224 -8491 4 31.0251 4.01663 37.6709 2.24281 6.85123 1.97341 -8492 4 30.7371 2.93942 36.6325 4.48759 4.53933 -4.77061 -8493 6 11.8397 14.3559 5.95013 17.712 13.5011 32.6048 -8494 4 11.8882 13.4483 5.64785 3.21485 -4.29204 1.16864 -8495 4 12.4103 14.428 6.79608 -23.3682 -9.2254 -38.5841 -8496 6 30.4732 33.6903 6.46877 -20.5926 30.9984 10.0988 -8497 4 30.0823 33.146 7.15741 -0.571027 -8.82817 5.88036 -8498 4 31.0368 33.1406 5.95739 18.3645 -25.6031 -16.3825 -8499 6 12.7874 0.539502 21.6719 -8.5062 -5.44338 -19.1545 -8500 4 12.0427 0.939271 21.1459 16.6961 -1.79193 22.1421 -8501 4 12.8959 0.982969 22.5241 -5.23507 7.86641 1.50036 -8502 6 52.7588 7.2218 26.198 16.8025 28.3515 6.33153 -8503 4 53.4065 7.96379 26.3423 -21.978 -17.2249 -4.05545 -8504 4 53.0631 6.80021 25.3976 -2.37526 -6.61619 -6.13258 -8505 6 39.7335 40.8867 3.73325 7.25622 8.93714 -16.4459 -8506 4 39.3445 40.0379 3.8542 -7.03998 -23.1188 -2.87281 -8507 4 39.6833 41.2661 4.59764 3.93702 15.0893 17.324 -8508 6 20.121 31.9222 21.9838 -6.71526 -6.20654 6.86321 -8509 4 19.4522 31.9772 22.708 13.7594 -4.46219 -12.9776 -8510 4 20.3423 32.8279 21.7497 1.41177 8.86705 -0.575134 -8511 6 12.8675 35.0031 4.45346 44.828 -17.7313 4.60062 -8512 4 12.2237 35.6716 4.40701 -39.658 29.9319 -2.18346 -8513 4 13.7076 35.4677 4.24983 -7.53722 -6.26381 -0.0905995 -8514 6 24.0625 33.6591 24.8433 7.47563 8.71661 -6.22666 -8515 4 23.7256 32.9086 24.3593 -5.011 -9.84395 -6.229 -8516 4 24.8651 33.8891 24.3525 -1.08488 0.504411 0.449776 -8517 6 40.1566 40.8925 22.745 3.65995 -18.1772 23.084 -8518 4 39.459 41.1173 22.1514 -10.4135 8.7075 -19.9273 -8519 4 39.655 40.5713 23.5068 11.7186 -0.819555 2.88668 -8520 6 15.5608 2.83174 38.4548 -17.961 4.93292 18.3513 -8521 4 14.8017 3.44348 38.6509 23.1729 -8.01231 -13.692 -8522 4 16.317 3.27039 38.0376 1.48109 9.53369 -0.90723 -8523 6 41.0116 9.17543 16.9495 15.4695 -4.08523 -13.4682 -8524 4 41.9148 8.77619 16.8957 -14.8555 5.86712 4.74383 -8525 4 40.5932 8.80873 17.73 -3.00249 -3.47282 8.63794 -8526 6 43.1871 41.3934 9.57744 -8.69666 -18.4537 3.1119 -8527 4 42.3844 40.9156 9.26306 10.8189 9.37287 1.53096 -8528 4 43.2581 0.273962 9.04681 -5.03874 9.79533 -5.6553 -8529 6 24.9044 37.9223 30.7828 -39.5154 -3.84946 22.9815 -8530 4 23.9949 37.8093 31.2426 42.0603 4.56965 -20.1335 -8531 4 24.7148 38.3736 29.9542 -2.24489 2.04808 -5.58176 -8532 6 2.22015 5.33054 16.4399 10.309 -8.52293 4.98471 -8533 4 1.84892 4.56193 16.8809 -9.36945 -1.25887 4.31387 -8534 4 3.13742 5.05729 16.2666 0.349453 6.20437 -4.74718 -8535 6 1.39717 14.946 19.1428 25.1228 15.6369 3.14315 -8536 4 0.624759 14.5201 18.7755 -11.3456 -6.79531 3.66607 -8537 4 1.29195 14.9418 20.1112 -7.64559 -2.97115 -5.19376 -8538 6 34.323 26.551 23.7054 -6.89575 15.1076 -7.90432 -8539 4 33.5377 26.6273 23.1515 0.482254 10.7241 -2.26295 -8540 4 34.2298 25.6735 24.0419 5.3831 -21.6418 13.1607 -8541 6 41.9187 21.8289 37.5387 -12.5221 18.6557 -0.654717 -8542 4 42.0641 21.2774 38.3263 -4.73604 7.9145 -4.0056 -8543 4 41.3184 22.5612 37.831 11.9642 -17.2916 1.51119 -8544 6 39.4187 37.6728 12.6286 4.8532 5.57593 -2.65087 -8545 4 38.7905 38.0203 13.2933 13.4683 3.10916 -9.30227 -8546 4 40.0129 38.4033 12.3216 -17.7433 -13.1833 12.1033 -8547 6 30.24 35.8848 2.88572 49.7685 -5.59713 18.4489 -8548 4 29.7974 35.0543 2.80033 -9.93294 -19.906 -6.06696 -8549 4 29.6668 36.5692 2.63166 -32.6151 32.1739 -11.9765 -8550 6 50.3574 12.2906 11.0327 -10.5999 -17.0186 -10.0309 -8551 4 50.5337 13.0768 11.5186 9.60091 28.0994 7.49192 -8552 4 50.105 11.6994 11.7365 -4.43527 -18.2768 5.14926 -8553 6 38.4177 1.51331 34.6454 7.78381 -17.0522 33.0946 -8554 4 38.2699 2.04814 33.8899 -7.54861 16.9144 -29.9652 -8555 4 38.0471 0.642488 34.4678 -6.5188 -5.83242 -9.72252 -8556 6 23.4539 32.2409 29.2188 -19.2438 22.9381 45.5983 -8557 4 24.0079 32.8299 28.7229 8.54827 0.527122 -15.0299 -8558 4 23.2413 32.797 30.0413 4.80705 -31.5817 -31.7916 -8559 6 36.5701 38.8746 8.90535 32.3223 -9.33237 29.2552 -8560 4 35.9325 39.4424 8.49935 -20.4423 23.0824 -8.61697 -8561 4 36.7801 39.1579 9.82993 -12.7327 0.605838 -19.3651 -8562 6 35.8737 15.8498 32.4386 8.92141 19.9053 -4.5399 -8563 4 36.1418 15.4504 33.2665 1.19933 -3.86396 7.25653 -8564 4 36.5179 16.5897 32.2945 -14.9335 -15.4114 1.1633 -8565 6 22.2892 21.8291 41.5841 -16.2626 10.7882 17.5339 -8566 4 22.1223 22.8053 41.6744 16.5914 -23.4811 -7.73209 -8567 4 23.1242 21.6534 41.1409 10.4107 9.35007 -4.50107 -8568 6 24.3606 38.6964 37.0146 17.4204 12.5043 -4.63866 -8569 4 25.2779 39.064 36.9978 -17.1771 -5.52971 -1.04157 -8570 4 24.4186 37.9719 37.6407 -4.78215 -9.12154 5.30794 -8571 6 45.8441 22.068 16.038 0.340293 -0.250982 -17.8101 -8572 4 46.1771 22.3609 15.1533 -8.50833 -8.1377 19.1007 -8573 4 45.4344 21.1785 15.9468 10.2139 13.0315 -4.03882 -8574 6 34.0918 26.1359 39.6112 38.0511 -8.91464 13.1738 -8575 4 33.1848 26.2338 39.3827 -25.4265 4.60567 1.8853 -8576 4 34.221 26.2032 40.5833 -12.0295 -1.62025 -11.2558 -8577 6 7.22533 36.1661 23.281 -59.3132 -5.14125 -34.652 -8578 4 7.26364 37.0581 22.9295 6.20379 9.34593 -2.3157 -8579 4 7.97006 36.0735 23.8015 59.451 -4.11437 40.0555 -8580 6 29.1637 40.7448 9.14206 -2.51826 7.72751 -13.9009 -8581 4 29.0444 40.3656 8.22324 15.9504 -2.90487 33.8878 -8582 4 29.7314 40.248 9.77766 -4.36215 -9.31282 -20.9127 -8583 6 29.3678 11.2357 1.30083 -35.1077 14.24 19.1284 -8584 4 28.4669 11.4731 0.940057 29.2946 -5.02339 11.2991 -8585 4 29.318 11.4379 2.27092 4.83193 -7.95866 -28.0539 -8586 6 30.9732 3.71267 14.0776 15.2348 -46.8383 -31.5788 -8587 4 31.4582 2.88428 14.3733 -12.5046 34.6753 7.46482 -8588 4 30.8397 3.49874 13.1133 -3.67459 15.4991 23.3176 -8589 6 29.7056 15.2804 38.2794 -11.9618 14.5562 -33.6413 -8590 4 30.2702 15.1354 39.0168 20.1567 -4.59268 23.419 -8591 4 30.0841 16.0123 37.7308 -6.59039 -15.0688 15.6005 -8592 6 36.6264 0.310111 29.1514 -5.04796 -7.83703 -2.09784 -8593 4 37.4271 0.819379 29.3706 -8.93441 4.46737 -4.0897 -8594 4 35.9914 0.856083 28.6484 15.2391 -5.29618 7.37908 -8595 6 47.6417 0.116275 23.248 13.5287 8.94531 -12.2883 -8596 4 47.0119 0.433387 23.8864 -15.3927 3.59754 12.8324 -8597 4 47.4641 41.0946 23.1357 -2.49679 -12.2922 2.24912 -8598 6 7.90637 37.1762 29.9388 8.54368 22.8184 26.8453 -8599 4 7.85301 37.2098 30.9449 3.45275 -3.37357 -41.2712 -8600 4 8.44496 37.9737 29.6897 -17.0006 -23.7003 10.0801 -8601 6 38.9296 24.2329 12.6383 15.5219 -16.6974 -22.776 -8602 4 37.9787 24.1601 12.7323 -9.9748 0.376678 1.49713 -8603 4 39.1449 23.5705 11.9215 -5.67631 22.059 20.3409 -8604 6 21.3179 26.2613 36.7933 11.7928 19.07 -1.51604 -8605 4 20.8397 25.6962 36.2015 -9.60619 -6.53459 -13.3894 -8606 4 21.5182 25.6957 37.5187 2.0605 -10.1459 21.1123 -8607 6 28.2262 23.3351 24.9913 6.08955 -0.748437 0.460504 -8608 4 28.2308 24.0016 25.6964 4.22655 -6.81745 -1.24962 -8609 4 29.0479 22.8075 25.0363 -13.73 7.51762 2.95505 -8610 6 38.3897 39.5713 14.5774 34.0997 -9.77678 18.0089 -8611 4 38.4779 38.8655 15.2987 -6.58584 29.8461 -29.0755 -8612 4 39.3026 40.0121 14.5422 -41.1029 -19.3921 -1.23505 -8613 6 26.0587 6.01626 38.1331 -7.56489 -16.2073 9.45163 -8614 4 26.364 6.92283 38.0032 14.5247 -0.467326 2.92393 -8615 4 26.7573 5.38712 38.4414 -3.391 26.9876 -7.34507 -8616 6 52.1178 17.2513 22.5128 -10.8492 5.54118 7.42996 -8617 4 52.8997 17.6733 22.1718 9.92427 15.7211 -4.0445 -8618 4 52.2219 16.3395 22.2718 -2.102 -18.0313 -4.16051 -8619 6 39.531 30.2011 31.4754 1.32431 5.33104 20.3977 -8620 4 40.1389 30.6029 32.1578 -26.1612 -12.9519 -10.6425 -8621 4 38.6407 29.9778 31.8528 28.462 12.4065 1.81878 -8622 6 19.6595 6.91666 12.7659 -14.5008 4.80913 14.0157 -8623 4 19.6887 6.47111 13.6446 7.23462 -2.42447 -18.0556 -8624 4 20.266 6.55226 12.115 5.2883 -10.9354 6.21868 -8625 6 32.4266 37.4954 40.1172 13.7501 31.88 -47.4625 -8626 4 32.7425 36.6266 39.9032 -2.48661 -20.9779 5.59445 -8627 4 32.1419 37.5817 40.9958 -11.8933 -10.3197 48.8363 -8628 6 39.7596 0.337115 6.09995 15.1421 -1.66777 24.2876 -8629 4 40.1534 1.22219 6.08152 -5.11901 -0.972083 -7.53812 -8630 4 40.1657 41.8549 6.90018 -9.37436 -2.20237 -11.3555 -8631 6 28.7751 10.1584 29.138 -2.01192 2.80513 -2.93319 -8632 4 27.8238 10.1744 29.001 -3.57801 1.81269 -4.50746 -8633 4 28.8919 9.80572 30.0274 6.34341 -2.0407 -1.56061 -8634 6 28.3442 21.074 10.6333 2.67716 -1.32955 -8.08167 -8635 4 28.7162 21.9756 10.7458 1.68682 -14.6392 -2.70928 -8636 4 28.9848 20.5267 10.1317 -8.30024 16.2649 10.4277 -8637 6 27.0693 28.6863 20.8775 28.7719 -2.37794 4.3254 -8638 4 27.7298 29.2434 21.3283 -4.93173 -3.86203 -1.8773 -8639 4 26.2334 28.9344 21.2444 -24.6691 6.36732 10.1211 -8640 6 39.6873 13.9804 33.4544 10.1398 -5.61125 10.7915 -8641 4 40.0465 13.7022 34.3167 -4.86 2.4669 -10.6871 -8642 4 38.7726 13.6755 33.4723 -5.1401 -2.85022 0.606476 -8643 6 25.4597 11.6576 34.3181 14.491 -28.0098 33.8508 -8644 4 24.8514 11.0162 34.7619 5.36553 12.2612 -15.2396 -8645 4 25.0161 12.1454 33.6493 -21.152 12.7672 -16.4478 -8646 6 27.5131 37.6326 21.427 -19.9573 -21.9997 -23.7283 -8647 4 28.2253 37.2064 20.96 8.67225 -9.05343 -17.242 -8648 4 27.9596 38.068 22.1137 20.557 20.5047 35.0331 -8649 6 30.5914 20.0695 28.6348 27.7431 -17.6396 19.2377 -8650 4 30.9836 19.3645 29.1801 11.8534 20.0629 -12.5158 -8651 4 29.6982 19.8076 28.6872 -39.6618 5.20089 -10.7407 -8652 6 42.3778 1.85684 14.9393 25.4983 -1.50621 30.9456 -8653 4 41.9471 2.41032 15.6124 -5.43016 1.03086 -4.74891 -8654 4 41.8361 1.80616 14.1675 -19.8596 2.00334 -17.6468 -8655 6 12.1616 12.5321 19.523 -14.5305 -6.69845 -4.01711 -8656 4 12.9939 12.0448 19.446 -0.641831 -5.10207 -0.17564 -8657 4 11.4028 11.9007 19.4323 17.6183 8.93718 0.635936 -8658 6 19.2173 1.21358 16.3673 12.2327 1.89672 9.92834 -8659 4 19.755 0.600796 16.911 -5.77615 9.45405 -9.5745 -8660 4 19.8129 1.9499 16.1364 -2.75311 -6.47505 -0.557351 -8661 6 9.48027 16.145 27.6887 18.4383 23.7652 -21.1678 -8662 4 9.95062 16.009 26.8224 -12.6846 -2.19341 25.2173 -8663 4 9.19893 15.3052 28.0262 -3.30777 -17.5687 0.945009 -8664 6 40.4566 26.1709 24.7821 -20.4805 41.2174 -0.532491 -8665 4 40.3628 26.7039 25.5991 10.1463 -19.7663 1.05084 -8666 4 40.0809 26.8306 24.1463 10.2053 -25.1837 1.88999 -8667 6 47.6675 17.6506 18.0225 -30.0634 41.3074 12.2788 -8668 4 48.2543 17.9981 18.7254 0.401995 -10.3127 -9.33209 -8669 4 46.9068 18.3177 18.0388 29.0716 -28.5939 -1.2112 -8670 6 36.6158 25.2629 4.18774 29.3736 28.0527 4.32129 -8671 4 36.5214 25.5758 5.09839 -16.0305 -5.04511 0.138651 -8672 4 37.2819 25.9232 3.86538 -16.6324 -17.2389 -6.3952 -8673 6 39.5728 35.3879 29.6636 12.278 22.7044 -7.26925 -8674 4 39.0499 34.5938 29.661 -5.91236 -8.06683 2.48368 -8675 4 39.3907 35.9006 30.4607 -1.7908 -9.53931 -1.38728 -8676 6 0.412001 14.6096 13.3342 2.26376 -2.5079 -14.7045 -8677 4 54.7802 15.2759 13.6175 -3.32355 6.27336 -0.974202 -8678 4 0.516441 14.0579 14.0961 4.60085 -12.9246 15.0473 -8679 6 12.196 27.3305 8.43326 10.0473 13.6833 14.0535 -8680 4 13.031 26.8669 8.51701 2.31971 -16.5604 -6.51009 -8681 4 12.4357 28.1833 8.85089 -17.0888 -3.60228 -10.1051 -8682 6 36.9057 14.8161 21.1198 30.6025 20.2317 -25.7914 -8683 4 37.0125 14.4244 21.9807 1.92342 -10.2074 20.832 -8684 4 37.7936 15.2053 20.874 -24.9082 -16.5351 5.08732 -8685 6 20.8486 4.94275 21.105 17.9022 -6.61396 -0.309651 -8686 4 20.374 5.67415 21.5228 9.17185 2.06744 3.08402 -8687 4 21.7751 4.88103 21.448 -24.8745 1.45604 -2.42669 -8688 6 36.7441 1.80601 7.63303 -8.86792 14.8212 -18.8361 -8689 4 36.3577 2.71345 7.77493 14.0998 -30.8697 16.0099 -8690 4 36.9898 1.34966 8.45182 -6.21638 14.7491 3.51078 -8691 6 12.2291 31.5076 37.4606 -20.8205 4.71929 16.9336 -8692 4 12.7789 31.2189 36.7301 -1.71439 -5.19212 -6.77065 -8693 4 11.3837 31.0118 37.4916 13.4088 3.21935 -3.86138 -8694 6 38.9875 41.6041 16.8806 -4.97036 -4.86794 -9.64455 -8695 4 39.4307 41.5716 16.0177 3.10466 0.790549 7.7281 -8696 4 39.367 0.410173 17.3903 6.57234 9.13046 2.45051 -8697 6 31.8971 27.2651 22.2536 0.475946 9.95506 -26.8482 -8698 4 31.2288 26.6192 22.5148 1.53167 3.01995 -0.700727 -8699 4 31.6701 27.5469 21.3168 1.33988 -13.0026 32.8364 -8700 6 42.7373 9.18402 25.5752 -16.5205 -8.12573 12.5156 -8701 4 42.0715 8.82875 24.9549 8.97347 3.93682 -3.18445 -8702 4 43.4726 9.55718 25.0966 9.17117 4.66181 -14.1392 -8703 6 50.9317 28.1762 25.3585 1.81467 11.9603 16.0249 -8704 4 50.4332 27.6858 24.699 -7.797 -4.30978 2.61883 -8705 4 50.6061 27.9816 26.259 1.82058 -3.16123 -16.2825 -8706 6 43.2019 19.6758 30.9261 -60.5069 12.608 18.1565 -8707 4 44.1121 19.7947 30.8273 58.227 11.7487 -4.80009 -8708 4 42.8317 20.4979 31.3452 14.2318 -14.5845 -6.94071 -8709 6 30.6579 14.0392 40.8099 -3.90856 28.8453 32.4485 -8710 4 30.2625 14.437 41.6588 6.78025 -22.1962 -33.7862 -8711 4 30.2388 13.192 40.6401 -8.31431 -9.09038 5.19898 -8712 6 20.9126 15.487 23.0255 1.81996 -1.2716 -0.577536 -8713 4 20.3529 16.1851 23.4151 9.86352 -5.06847 -1.26552 -8714 4 21.845 15.6804 23.2451 -11.0139 0.781722 1.09061 -8715 6 34.2266 0.759926 35.8266 5.91607 -35.831 36.3238 -8716 4 34.6699 1.4486 36.3596 -6.19332 -9.6922 -6.67054 -8717 4 34.0788 41.8551 36.4474 5.42693 41.8664 -30.5853 -8718 6 38.9146 36.9114 35.918 21.2173 -10.8751 17.2864 -8719 4 39.7829 37.095 36.338 -12.434 5.66027 -11.9648 -8720 4 38.7157 36.033 36.27 -5.46808 2.11761 -7.10044 -8721 6 45.1412 25.209 22.7799 -9.21588 11.7282 35.1943 -8722 4 44.1635 25.1535 22.9277 18.3683 -4.67801 -8.38153 -8723 4 45.395 24.8019 21.9606 -9.08047 -9.94082 -17.9945 -8724 6 40.6079 0.819632 35.9543 -10.1658 30.0784 -5.29357 -8725 4 40.5743 41.7978 35.9297 8.39322 -37.6139 4.80851 -8726 4 39.8853 1.04128 35.3423 10.5918 6.58535 9.58714 -8727 6 11.0481 28.354 35.0263 -7.05837 2.15472 6.15391 -8728 4 11.0065 27.7661 35.7937 6.20016 -1.50115 -1.31869 -8729 4 10.2774 28.923 35.1598 -2.00076 2.29074 -4.05614 -8730 6 20.214 13.5993 35.8619 28.0429 -16.4719 23.5579 -8731 4 19.4963 13.9327 35.3857 -45.1468 12.1599 -23.9045 -8732 4 20.9404 14.0304 35.4284 21.7873 4.64258 -6.99651 -8733 6 39.6259 5.13927 1.77541 6.3837 10.5905 23.0009 -8734 4 38.815 4.76887 1.43754 -8.89155 -4.8304 -7.9643 -8735 4 40.2998 5.10051 1.09544 5.70124 1.55861 -13.0764 -8736 6 30.2644 30.8765 32.4376 2.45351 13.5189 11.7538 -8737 4 29.6638 31.1848 33.1457 1.37952 -7.29152 -6.97913 -8738 4 29.9065 30.0722 32.0512 -6.5155 -7.29863 -0.0927806 -8739 6 14.5561 10.991 22.8667 10.081 16.7623 43.7388 -8740 4 15.1677 11.6459 23.3133 -13.9792 -18.4015 -26.7579 -8741 4 13.9431 10.829 23.6181 3.59137 -7.6484 -17.8174 -8742 6 20.7554 13.9367 3.0184 -22.7431 -13.2276 -14.851 -8743 4 19.9027 13.7405 2.57467 24.082 -4.954 3.77469 -8744 4 20.4786 14.7044 3.49738 5.42185 19.6619 18.2233 -8745 6 41.2999 4.28373 12.6115 -5.11846 11.2121 16.06 -8746 4 40.5902 3.66826 12.7964 -5.45414 -3.74116 2.1628 -8747 4 41.646 4.04628 11.766 6.8814 -9.70345 -22.8074 -8748 6 10.8486 24.7151 21.7079 -22.0181 20.7635 -2.99902 -8749 4 10.06 25.055 21.1824 26.1755 -20.3138 8.68391 -8750 4 11.196 23.8735 21.3742 -8.74412 -0.217035 -8.2032 -8751 6 53.5851 20.8962 34.3615 -20.5776 4.99959 -7.54911 -8752 4 54.5312 20.9399 34.3174 23.7346 3.60458 -0.717784 -8753 4 53.3344 20.0378 34.731 7.46747 5.54606 -4.26157 -8754 6 14.8822 4.84805 30.4483 -9.71325 -6.00753 -19.6684 -8755 4 14.771 4.94284 29.4789 1.77408 0.90497 14.7496 -8756 4 14.5561 3.94513 30.5986 4.49673 6.24836 5.5759 -8757 6 48.9024 37.1196 13.1149 -36.5603 24.8322 -14.1851 -8758 4 47.9606 37.2057 13.4129 22.1922 -3.12109 -3.19476 -8759 4 49.2987 36.4589 13.6532 13.3268 -16.5999 12.901 -8760 6 26.8059 19.3169 7.54434 -4.26945 -4.42367 7.83904 -8761 4 27.1766 18.4867 7.22339 -3.92405 -4.32352 -1.07463 -8762 4 27.3968 19.9842 7.20607 8.782 12.6164 -5.40832 -8763 6 17.6305 11.9358 39.0864 -20.6439 9.19078 16.9487 -8764 4 18.5077 11.609 39.0209 28.8526 -12.5757 -8.06323 -8765 4 17.5232 12.1203 40.0373 -6.81014 1.23205 -8.73836 -8766 6 49.927 14.591 8.61416 15.5742 -26.1486 -8.96269 -8767 4 49.2009 13.9524 8.72368 2.87529 10.9098 3.94828 -8768 4 49.6414 15.4659 8.85563 -10.1676 20.5637 7.32703 -8769 6 32.3582 34.9735 31.5167 -0.414276 11.4895 24.1707 -8770 4 32.1283 34.3825 30.8126 -1.81559 -4.89127 -12.898 -8771 4 32.4479 35.8663 31.1601 -0.97656 -3.19104 -3.1743 -8772 6 11.821 22.2226 21.3194 1.12988 -20.2292 -31.7924 -8773 4 12.2035 21.6949 20.5593 -17.646 16.3031 19.3587 -8774 4 12.5076 22.1609 21.967 14.4856 1.86701 17.8995 -8775 6 33.8479 9.95925 13.6297 5.85555 4.94861 0.641841 -8776 4 32.9412 9.60258 13.4965 20.4646 2.44791 -13.0803 -8777 4 34.46 9.81143 12.8638 -25.0852 -4.3509 9.75457 -8778 6 25.5216 36.3896 1.4985 -3.83916 -1.90754 -5.44184 -8779 4 26.1733 36.851 0.947779 -3.43756 3.58217 3.68691 -8780 4 24.6678 36.8514 1.38848 10.8858 -3.23471 -1.95008 -8781 6 26.2654 10.5456 9.75524 -44.5011 8.64206 25.1655 -8782 4 25.6084 11.269 9.60979 18.788 -4.56637 -6.88642 -8783 4 25.8198 10.0845 10.5139 21.0346 7.54764 -16.1236 -8784 6 25.0247 0.792222 40.9035 16.6629 9.7536 -9.8108 -8785 4 25.2766 0.410293 40.0414 -7.0744 -0.853038 7.71488 -8786 4 25.4535 1.67289 40.8914 -6.39875 -10.0211 5.33714 -8787 6 46.2514 3.92331 24.811 2.29787 -10.4124 3.565 -8788 4 46.4476 4.07649 23.8793 1.84574 -7.0337 -1.43198 -8789 4 46.0806 2.96577 24.928 -3.00701 8.9366 -8.52535 -8790 6 21.593 13.605 29.211 2.46069 1.87638 12.7155 -8791 4 21.5518 14.2847 29.9136 -0.977025 -6.07097 -8.18011 -8792 4 21.3035 14.062 28.4178 -1.02829 3.62716 -1.29843 -8793 6 36.772 38.3747 0.364057 -13.57 -14.6746 -5.92565 -8794 4 36.4241 39.1227 0.863015 -2.10343 5.30459 -0.282121 -8795 4 36.0255 37.7419 0.250491 13.2024 11.0478 3.68109 -8796 6 19.3024 17.6377 24.0664 34.4056 30.1631 -22.0465 -8797 4 18.4191 17.3498 24.1437 -40.9446 -15.7866 5.54764 -8798 4 19.2946 18.2748 23.3003 0.347271 -14.2409 17.5238 -8799 6 23.1729 12.6936 3.50527 -23.4203 -1.67393 -9.32385 -8800 4 22.2599 12.987 3.28408 10.1497 2.83055 6.60862 -8801 4 23.2366 11.8468 3.05081 2.04707 -0.882582 2.79058 -8802 6 37.8929 8.88926 35.4532 -15.1513 -19.5409 -35.7954 -8803 4 38.8496 8.85033 35.2802 -3.80753 -1.00094 -0.145651 -8804 4 37.4409 8.32345 34.738 24.7998 24.8105 28.8968 -8805 6 14.3214 15.124 36.1936 10.1777 -8.45579 -11.337 -8806 4 15.1189 15.6285 36.3983 0.383997 -0.909139 3.4786 -8807 4 13.728 15.2114 36.9249 -8.84751 6.7001 14.2991 -8808 6 35.0764 0.951221 33.027 4.39995 -0.747562 -23.3066 -8809 4 34.9707 1.92678 33.0471 -0.901583 -14.825 16.9845 -8810 4 34.929 0.489106 33.8671 -4.79444 18.9729 2.67887 -8811 6 50.9368 0.508345 17.9996 -16.1068 -2.11236 -10.8013 -8812 4 50.7363 1.3993 17.6607 6.59543 -7.82408 5.75367 -8813 4 50.2126 41.8571 17.6452 15.113 5.01242 7.08044 -8814 6 26.2276 30.5707 0.943679 2.98972 25.4521 29.679 -8815 4 26.9747 31.0717 1.30878 -11.5718 -5.07384 -0.177367 -8816 4 26.5685 30.1289 0.190254 7.28539 -15.5247 -23.6744 -8817 6 18.5631 38.2963 4.56281 15.0547 -0.00169581 -1.07608 -8818 4 17.6313 38.4808 4.44067 -9.04909 6.52025 -3.84653 -8819 4 19.0145 38.7079 3.79419 -7.75189 -5.39823 9.30868 -8820 6 31.1327 5.08368 4.10816 20.0095 -18.3558 -6.33253 -8821 4 31.8391 4.51927 4.54922 -26.0459 18.0586 -17.7145 -8822 4 31.2112 4.96997 3.12633 -1.20575 2.29654 19.098 -8823 6 26.4386 21.9021 1.48262 11.6176 -12.3641 -2.34526 -8824 4 26.4119 22.77 1.11333 -7.24657 26.8604 -8.21156 -8825 4 27.3591 21.6321 1.37052 -1.3799 -4.61827 0.12427 -8826 6 39.218 11.6975 22.8013 10.5737 17.0434 4.86912 -8827 4 39.8837 11.6898 23.5135 -8.12783 -9.21376 -3.17514 -8828 4 38.7576 10.8611 22.7762 -0.316566 -9.51531 5.7902 -8829 6 13.6104 36.3454 30.6448 12.2201 31.8005 15.4331 -8830 4 13.9411 37.0787 31.1944 -5.64032 -6.12374 -20.8561 -8831 4 13.4819 35.6769 31.3099 -5.82879 -19.5305 -1.97286 -8832 6 50.5737 9.8729 9.34449 -28.5439 -15.8542 -0.594603 -8833 4 49.6941 9.5296 9.68217 24.5077 10.0039 -8.16891 -8834 4 50.7802 10.6382 9.87905 1.56032 8.49656 8.37591 -8835 6 49.6568 40.2957 22.5808 3.13406 -4.17489 -1.45496 -8836 4 49.9643 39.4131 22.2832 -6.04563 10.523 5.74674 -8837 4 49.4657 40.2311 23.537 6.08697 -6.10842 -7.72776 -8838 6 7.19984 41.3227 28.8903 -1.52952 20.6044 28.9443 -8839 4 7.18166 41.5789 29.8666 2.82963 -8.74683 -37.3978 -8840 4 7.33954 0.237732 28.3754 1.09714 -11.2116 9.436 -8841 6 13.0357 18.018 25.3358 19.442 16.9905 44.3108 -8842 4 13.6166 18.1186 24.5548 -1.12298 4.17303 17.3747 -8843 4 13.5323 18.3306 26.2146 -21.9746 -20.4015 -59.5043 -8844 6 50.052 19.589 2.43093 38.9512 -4.48133 -22.8803 -8845 4 50.7424 19.2598 1.79532 -23.4729 1.49397 14.1456 -8846 4 50.5528 20.298 2.8491 -7.87613 8.00017 8.65361 -8847 6 28.349 40.9814 24.5177 14.9096 -9.01222 -0.77751 -8848 4 28.8235 40.5955 23.7606 -4.31864 4.07524 4.80921 -8849 4 27.7156 41.5877 24.1507 -14.6867 11.3415 -7.76415 -8850 6 19.4129 5.36023 29.5381 -15.1481 -17.3665 11.3948 -8851 4 20.1134 5.96028 29.2689 3.1753 8.4576 0.913483 -8852 4 18.7407 5.8353 30.064 8.44892 1.72514 -6.85652 -8853 6 35.3149 40.1584 22.2743 -5.4761 3.67764 -22.0922 -8854 4 35.6772 39.8166 23.0859 3.70556 0.822605 11.3301 -8855 4 35.3088 41.1243 22.2924 6.6179 -0.993945 11.5959 -8856 6 16.1846 33.7767 9.75922 -0.358556 8.53088 17.0233 -8857 4 15.9516 33.2005 9.03859 1.48669 -13.8429 -11.0903 -8858 4 15.6081 34.5411 9.70154 -4.21994 3.45608 -1.0308 -8859 6 17.3638 40.6569 20.2187 0.0478101 13.797 12.0053 -8860 4 17.2553 39.7868 20.6094 -1.96745 -8.64858 -4.42208 -8861 4 17.5346 41.2369 20.9867 0.609446 0.00823871 -10.958 -8862 6 20.5168 9.71855 9.57392 23.3053 8.23996 -15.5036 -8863 4 21.1612 10.0129 10.2371 -5.46071 -1.58749 -5.90152 -8864 4 19.8092 9.36498 10.0856 -20.4585 -11.5711 12.7624 -8865 6 47.4431 20.1927 21.3797 46.3705 -23.5901 12.8176 -8866 4 48.2534 19.5912 21.2825 -32.1103 24.8918 7.30718 -8867 4 46.9863 20.0806 20.5604 -17.463 -0.0836882 -22.1962 -8868 6 38.4119 40.7863 37.8131 4.58972 -16.3007 -8.86139 -8869 4 38.2015 41.716 37.7675 -2.07213 19.1933 -0.538509 -8870 4 38.1163 40.4897 38.6817 -2.89344 0.451293 5.51523 -8871 6 4.78246 1.95264 13.1142 -0.962758 -11.3299 -4.56483 -8872 4 4.86308 1.24617 12.4504 1.09441 11.0888 1.2667 -8873 4 4.58181 1.48453 13.9266 -0.88642 0.622503 9.15822 -8874 6 46.8366 29.0044 2.17213 -21.5573 10.7483 2.0879 -8875 4 46.5703 29.0979 3.11526 14.9241 -10.138 -17.8178 -8876 4 47.6533 28.5191 2.04264 7.39387 -6.09514 13.7966 -8877 6 37.4332 26.1628 25.6457 0.476866 -1.57884 -3.35254 -8878 4 37.1432 25.5044 26.2761 -1.46501 -6.7424 3.65975 -8879 4 36.6379 26.5951 25.3475 -3.92424 6.80267 -0.609098 -8880 6 27.3215 4.19863 19.437 6.03131 -5.89417 1.59018 -8881 4 28.0693 4.5088 18.8685 -19.6633 0.0824503 4.70742 -8882 4 26.4692 4.57526 19.1444 8.48727 3.90116 -6.43998 -8883 6 29.5816 35.1763 32.6702 11.3433 -15.1984 -13.0035 -8884 4 29.498 34.4257 32.0309 -0.34209 19.1564 15.9908 -8885 4 30.487 35.489 32.5363 -2.16348 -1.10322 -0.755163 -8886 6 51.6039 27.3804 34.6228 -16.2846 20.7721 3.47149 -8887 4 51.9118 26.5342 34.8842 8.46829 -31.6815 14.0056 -8888 4 52.043 27.5552 33.7939 4.07896 7.882 -12.2594 -8889 6 26.213 15.718 22.6983 4.45652 -13.2698 4.19624 -8890 4 25.9644 16.5706 22.3629 -2.74203 26.12 0.0562263 -8891 4 25.9462 15.1046 22.0171 -4.99078 -11.3651 -6.14484 -8892 6 36.1284 41.1872 15.4686 -15.9675 5.34592 -0.326298 -8893 4 35.5872 40.4009 15.2728 11.0637 0.363161 -0.898578 -8894 4 37.0593 40.962 15.4319 4.98109 -12.2962 -3.97184 -8895 6 18.4605 8.81439 11.2163 9.85092 25.9028 -2.05591 -8896 4 18.8222 8.21565 11.8732 -2.65799 -9.87079 3.83174 -8897 4 17.6938 8.4288 10.8111 -9.58752 -11.4871 -1.05984 -8898 6 30.2054 21.3176 23.2008 0.0321998 2.06754 0.100272 -8899 4 29.9991 22.2239 22.9456 -2.76699 -3.99559 -1.97847 -8900 4 29.5697 20.7243 22.7648 2.21136 7.68347 0.454199 -8901 6 22.7376 2.20942 34.8415 -7.06988 -25.8748 21.345 -8902 4 22.3263 1.32441 34.7915 6.81547 13.2405 5.99888 -8903 4 22.6443 2.51876 33.959 0.748808 17.6695 -28.972 -8904 6 12.6779 2.74229 12.3423 -3.02369 13.9186 -14.8572 -8905 4 12.6684 3.63953 11.9163 1.20981 -22.4864 12.4813 -8906 4 13.1874 2.20366 11.7175 -0.841633 0.53426 4.77071 -8907 6 24.0891 30.0714 14.5767 2.26717 -13.4561 -11.586 -8908 4 23.8674 30.8343 15.1637 -15.8173 -12.4528 -15.4046 -8909 4 23.3482 29.6562 14.0436 11.1594 27.3113 22.4963 -8910 6 0.0169515 27.9037 22.8558 -22.9231 2.02358 -4.19556 -8911 4 54.5653 28.3586 23.5905 7.88497 -1.22395 1.09473 -8912 4 54.2173 27.7016 22.3138 13.4725 -1.40758 1.11908 -8913 6 12.3768 4.48401 25.8984 -1.01368 1.72138 -1.86924 -8914 4 11.999 5.34556 25.8124 1.61778 23.022 -11.6285 -8915 4 11.6412 4.07623 26.3496 -0.520107 -24.5543 7.98643 -8916 6 50.6552 14.4595 5.90563 -9.7075 2.6569 37.2621 -8917 4 51.421 15.0215 5.71422 1.2699 0.536098 -2.53407 -8918 4 50.4862 14.5526 6.9139 5.60038 -4.97296 -46.1729 -8919 6 52.566 22.8545 20.1304 -1.0263 1.56712 -17.1158 -8920 4 52.8493 23.3468 20.8979 1.30497 -0.175929 17.7779 -8921 4 52.7622 23.494 19.4302 -3.4332 -7.01119 -2.14697 -8922 6 43.5747 16.5432 12.8706 26.1082 -6.15301 -20.1459 -8923 4 44.3581 16.1075 12.4177 -27.2623 16.7463 17.9516 -8924 4 42.8105 16.3628 12.3102 -5.85283 0.59737 -2.51971 -8925 6 15.9643 16.7491 40.5889 4.71604 31.6512 -1.38133 -8926 4 16.4157 17.2981 39.8953 -10.7397 -16.8436 16.4649 -8927 4 15.6568 17.4119 41.253 8.12177 -13.8769 -14.2686 -8928 6 23.4093 18.8548 23.8539 -16.419 -4.21219 2.12821 -8929 4 23.4427 19.3457 24.6888 0.296298 -1.81048 -2.30579 -8930 4 22.5005 18.9913 23.5305 9.65682 -2.29273 2.24785 -8931 6 46.4286 3.27372 31.8783 1.50761 -1.36157 -5.63512 -8932 4 45.559 3.26328 31.468 -2.27736 -0.687336 -10.0334 -8933 4 46.2409 3.35124 32.8099 7.04458 2.11131 4.36323 -8934 6 43.404 41.0501 12.2894 -4.74196 -21.563 6.60959 -8935 4 43.6943 41.7945 12.8025 5.82787 10.392 6.16968 -8936 4 43.4921 41.2918 11.3656 -0.276957 5.00436 -10.4807 -8937 6 7.4944 32.479 29.5886 4.16519 42.7458 -9.72808 -8938 4 8.11522 31.7905 29.7504 15.4265 -22.4366 1.70525 -8939 4 8.06583 33.2868 29.4339 -18.9062 -19.2919 1.43274 -8940 6 4.77786 31.6555 22.5097 8.01353 -0.237295 6.09653 -8941 4 5.36252 32.2279 23.0433 -12.0801 1.27555 -9.50519 -8942 4 4.10079 32.1892 22.0697 5.55495 3.82082 5.5049 -8943 6 48.8707 26.8644 2.67473 3.24755 -50.1854 9.90243 -8944 4 49.7841 26.6767 3.05593 -33.5394 4.93648 -17.7122 -8945 4 48.3402 25.9967 2.74374 27.3415 43.0547 -3.91521 -8946 6 35.3704 23.2724 21.6151 -20.572 -8.60634 18.7236 -8947 4 36.1531 22.7653 21.8467 10.3528 0.763668 -1.9928 -8948 4 35.5272 23.8633 20.8878 14.153 10.3741 -19.8739 -8949 6 9.81162 37.7752 27.3066 -7.93747 -1.88745 -15.4111 -8950 4 9.56608 38.5967 27.7736 11.3364 -13.9943 4.65066 -8951 4 10.53 37.2723 27.7168 -2.00951 8.75096 9.6206 -8952 6 6.95784 10.9804 26.0002 -14.8513 -9.26658 -13.6642 -8953 4 6.43708 10.2284 25.6287 17.7452 16.2397 9.86134 -8954 4 7.32481 10.7062 26.8445 2.87033 -7.35616 11.341 -8955 6 15.9925 34.488 38.9165 -7.91378 13.4212 -4.2482 -8956 4 16.1125 33.5888 38.5756 -0.423195 -0.537141 7.5048 -8957 4 15.8451 34.497 39.8859 4.12272 -10.609 -16.5735 -8958 6 24.136 17.3087 36.1669 -1.30362 -38.1211 0.134245 -8959 4 24.6388 17.5417 36.9612 2.54889 -4.89456 5.81445 -8960 4 24.0565 16.298 36.169 6.29988 31.3296 1.89661 -8961 6 29.9661 19.0481 5.63552 -3.51045 -24.0694 26.081 -8962 4 30.059 18.4844 6.44318 1.40084 7.89656 -22.1005 -8963 4 29.4651 19.7932 5.9612 -6.50009 17.0844 0.645364 -8964 6 41.2323 14.2118 25.8708 0.538972 29.9242 -13.4546 -8965 4 41.1167 15.1135 25.4912 3.21098 -20.1981 4.76589 -8966 4 41.3237 14.3734 26.8138 2.01946 -2.10135 6.77926 -8967 6 30.5977 17.7991 37.3648 -2.09385 13.2702 -7.29075 -8968 4 30.1274 18.3693 36.6865 13.7219 -8.47854 26.2153 -8969 4 30.6897 18.2674 38.2325 -7.09621 1.58925 -18.9017 -8970 6 36.2622 35.7606 28.8616 -21.9344 -15.8478 13.9239 -8971 4 36.666 34.9659 29.2737 0.470987 14.2463 -5.72758 -8972 4 36.9609 36.34 28.5862 17.8584 7.52692 -3.58957 -8973 6 0.186361 37.881 20.3783 -19.4052 1.06805 -13.5296 -8974 4 0.625244 37.258 20.9754 1.43275 1.23053 -1.08677 -8975 4 54.3963 37.4077 20.0073 13.2242 8.68111 6.51083 -8976 6 49.5157 39.5849 25.2719 1.34086 -27.0873 28.6785 -8977 4 49.1738 39.8396 26.1677 9.83442 -4.23573 -27.15 -8978 4 49.8309 38.6394 25.3482 -11.1501 31.2987 0.525887 -8979 6 21.6501 10.2052 29.3652 1.38747 -32.8599 -17.8213 -8980 4 21.4815 11.1062 29.1158 -2.57329 19.5966 11.1399 -8981 4 21.7962 10.0736 30.3036 1.32123 13.0863 10.38 -8982 6 36.4484 30.062 0.133613 20.0221 49.2239 1.07318 -8983 4 36.3691 29.4748 41.3122 -8.72629 -28.1564 -18.1683 -8984 4 36.9877 30.812 41.6437 -16.8233 -22.5363 23.3328 -8985 6 35.2366 23.3806 39.1473 20.2218 -67.2813 -35.6269 -8986 4 34.8925 23.3776 38.2436 -2.85003 -5.00903 7.3464 -8987 4 34.9678 24.1769 39.4749 -24.7984 75.1446 29.9953 -8988 6 25.4958 17.6356 38.7131 -1.05403 5.23051 -13.5311 -8989 4 26.2557 17.1099 38.9745 11.6052 -6.82876 2.03202 -8990 4 25.6896 18.4914 39.1039 0.551448 5.55093 4.31103 -8991 6 32.6851 1.71412 15.3757 -17.1832 -26.0249 32.2484 -8992 4 32.9133 1.90091 16.3255 -0.281287 1.06348 -22.8896 -8993 4 32.1369 0.878474 15.451 14.5551 28.5253 -7.92953 -8994 6 2.74577 26.2334 40.164 -3.83079 -17.2464 -24.8373 -8995 4 2.52975 26.8073 40.8689 -10.0885 25.811 23.4985 -8996 4 3.46379 25.6906 40.4857 13.7859 -11.3271 -3.22577 -8997 6 25.4247 39.5803 6.65235 -3.20662 25.1889 -29.4644 -8998 4 26.0108 39.0547 7.19361 -10.0861 -10.9475 13.3666 -8999 4 24.4797 39.508 6.87242 11.3389 -11.2764 10.0712 -9000 6 3.89558 2.45526 21.1915 20.3615 -74.5786 -16.468 -9001 4 3.45835 1.54866 20.9342 19.9424 46.4596 11.9477 -9002 4 3.20863 3.06758 21.3193 -35.5841 29.5388 2.2294 -9003 6 19.428 35.9937 6.17834 -35.0483 8.79483 10.2733 -9004 4 18.6638 35.8781 6.77432 14.6839 -5.07873 0.0324743 -9005 4 19.0495 36.6291 5.56439 9.71061 8.85688 -10.7695 -9006 6 53.6717 10.8593 34.7958 -7.0633 -31.3632 -8.45381 -9007 4 53.6341 10.4895 35.6991 7.39736 18.8685 -12.2464 -9008 4 53.8829 11.7827 34.7263 4.03482 19.5096 16.0301 -9009 6 51.2684 14.0949 34.672 -8.65676 -1.63762 -26.9588 -9010 4 50.7715 13.5641 33.9816 13.3581 12.906 22.4054 -9011 4 51.0369 13.7812 35.5532 -5.90867 -9.66849 3.74112 -9012 6 14.4369 40.0234 28.032 -17.7583 12.3896 33.8878 -9013 4 13.8707 39.2432 27.9284 6.73847 -3.79593 -5.43806 -9014 4 14.0697 40.4885 28.8439 14.5888 -10.3946 -25.5694 -9015 6 36.0586 40.8581 1.30985 34.3129 5.11816 -1.28261 -9016 4 35.3876 41.022 1.96214 -5.4524 5.11716 12.4526 -9017 4 36.8901 41.3246 1.61712 -30.5352 -10.0787 -2.88322 -9018 6 32.5955 21.8673 9.61487 11.2903 3.47268 22.8686 -9019 4 32.2562 21.1899 9.03409 -3.19899 -6.31213 -16.1683 -9020 4 32.8032 22.6511 9.09762 -2.66985 0.307575 -11.8305 -9021 6 53.7554 11.4583 10.0657 12.5408 -15.0223 -21.3323 -9022 4 54.7025 11.5478 10.261 -4.15933 2.55001 3.12883 -9023 4 53.7605 10.7769 9.36125 -9.51558 7.63224 9.70748 -9024 6 25.4365 2.06658 35.0039 -16.8474 18.4627 -14.151 -9025 4 25.5892 2.94197 34.5728 -1.09755 -16.5277 9.12484 -9026 4 24.4603 2.05675 35.1439 15.8828 -2.54758 -2.86629 -9027 6 38.4258 16.3759 27.0837 10.3035 -3.82582 33.4754 -9028 4 38.4229 16.0362 28.0039 4.2105 -6.34073 -14.2668 -9029 4 38.1536 17.2766 27.2341 -1.96409 14.1736 -9.55492 -9030 6 11.9898 11.8134 38.076 -13.826 -2.82892 7.4824 -9031 4 12.2944 12.4411 38.7385 15.2198 2.85174 -2.31876 -9032 4 11.0532 11.721 38.3132 2.05768 -5.32701 -10.6008 -9033 6 21.1746 40.7334 25.8979 40.4357 -13.6237 -24.6728 -9034 4 20.6698 41.4315 25.4918 -16.6357 14.348 -0.996217 -9035 4 20.789 40.494 26.7242 -19.3448 -1.94923 24.9485 -9036 6 5.46053 31.2633 28.1043 10.2831 7.82506 0.3012 -9037 4 4.85681 31.7249 27.5011 4.53193 2.9664 -2.03256 -9038 4 6.18919 31.875 28.3487 -9.19227 -4.78386 -2.03476 -9039 6 38.5722 10.4288 26.6273 1.75688 -6.42268 2.69181 -9040 4 39.2722 10.957 26.2192 0.13713 -2.38088 1.965 -9041 4 38.9883 9.93745 27.351 -0.726559 6.62326 -4.692 -9042 6 34.5654 22.2334 5.77474 -10.6824 6.04198 20.2303 -9043 4 33.6505 22.4646 6.03122 6.34024 -5.77168 -8.80249 -9044 4 35.1097 22.5906 6.49609 1.67963 -6.25138 -9.01327 -9045 6 19.5088 23.4111 8.91157 10.1707 -16.3121 14.7533 -9046 4 19.7449 23.1021 9.7973 -5.16612 6.6008 -0.0119594 -9047 4 19.9964 22.8054 8.35541 -0.106246 2.40248 -11.9056 -9048 6 19.7526 39.1673 18.9392 3.41392 2.41259 -7.44399 -9049 4 20.3112 38.9942 19.7162 -9.66179 4.90282 -1.08801 -9050 4 18.9888 39.695 19.2431 8.6955 -6.10904 -0.220035 -9051 6 19.0066 16.6479 37.8897 24.9266 -16.0788 2.00499 -9052 4 18.1904 16.5622 37.4269 -20.8911 -0.0800444 -12.5516 -9053 4 18.858 17.3198 38.5387 -2.83386 13.0664 11.2213 -9054 6 46.1457 18.3015 34.4662 -13.7163 3.02283 10.6817 -9055 4 46.1788 17.7584 33.6837 2.50627 -7.36872 -12.652 -9056 4 45.2295 18.6352 34.4793 7.83367 -3.11582 0.242547 -9057 6 37.6724 4.92727 10.6572 20.6306 -0.498941 -29.5329 -9058 4 38.5268 5.23995 10.2493 -20.9001 -6.48587 16.5696 -9059 4 37.1025 4.69637 9.88262 10.9132 7.05613 26.3995 -9060 6 51.9879 36.0003 6.84307 -0.0349375 1.28893 10.7684 -9061 4 52.0937 36.793 6.30051 2.19835 -5.62517 4.5242 -9062 4 52.7425 36.0295 7.48232 -7.26034 2.01661 -20.7899 -9063 6 26.6747 12.3215 0.993928 -15.5873 -26.456 -19.7503 -9064 4 26.4829 12.3908 1.92985 -0.4811 3.80705 11.7504 -9065 4 26.1241 11.5295 0.732228 15.7893 19.669 4.48242 -9066 6 51.344 35.7707 13.5244 -1.45768 15.8539 -2.86245 -9067 4 51.4515 36.3837 12.7824 1.55721 2.40741 1.90229 -9068 4 51.4783 34.9191 13.1366 6.57206 -21.9808 -6.55402 -9069 6 1.98876 3.63996 24.5779 3.53339 50.093 -23.5227 -9070 4 1.66274 3.05681 25.2088 -14.7773 -39.8355 33.4132 -9071 4 1.68527 4.50485 24.9411 8.95614 -12.6616 -11.2736 -9072 6 33.5242 15.2767 16.4494 0.0755523 4.59339 -41.038 -9073 4 33.5553 15.5138 15.4787 -3.36737 -9.15609 28.4742 -9074 4 33.81 16.089 16.8707 2.78154 5.67933 12.8052 -9075 6 10.7376 26.5972 37.3568 -53.543 46.6204 -3.13137 -9076 4 10.2745 27.0143 38.1249 4.48347 -4.84659 -12.5134 -9077 4 11.4659 26.2171 37.7527 59.8403 -33.1666 26.4091 -9078 6 39.618 8.36935 32.0025 -18.1555 9.41152 20.5333 -9079 4 39.1948 8.91554 32.6893 14.8148 -9.04413 -3.7523 -9080 4 39.059 8.55692 31.2545 -3.75745 -0.899113 -17.0741 -9081 6 48.8678 24.2325 11.5968 8.56011 -30.9839 -7.0275 -9082 4 49.2355 23.3258 11.4382 -10.5357 21.2684 5.64902 -9083 4 49.6052 24.6956 12.0119 -1.11745 3.30341 0.0123828 -9084 6 15.7966 8.52145 22.5402 1.04041 9.04678 1.57429 -9085 4 15.9271 8.56462 21.5825 -0.708828 -3.15413 5.43528 -9086 4 15.5351 9.42629 22.7739 -0.982858 -3.13072 -0.606507 -9087 6 16.9647 23.5461 7.94634 -33.4976 4.63454 -7.56842 -9088 4 17.0449 23.8842 7.03772 17.2153 -3.19264 11.7182 -9089 4 17.7681 23.4723 8.45101 25.4501 5.7081 -7.03081 -9090 6 42.4788 26.856 6.32162 3.09129 16.6976 -8.96027 -9091 4 41.8509 27.5547 6.55233 4.05081 -5.7053 1.31186 -9092 4 43.1337 27.3683 5.79469 -5.76138 -9.42264 4.17624 -9093 6 36.7899 4.80361 30.039 -6.11534 9.52442 2.68488 -9094 4 37.0233 4.89717 30.9689 4.03122 4.23205 -0.240484 -9095 4 36.2783 4.00567 29.9694 -7.15291 -10.8132 -0.980928 -9096 6 45.6188 11.6101 3.31184 17.0103 13.4398 12.4748 -9097 4 45.8378 10.6807 3.43524 1.11174 -8.0511 2.33471 -9098 4 46.2756 12.0957 3.86714 -12.3909 -9.3108 -12.4209 -9099 6 24.8953 36.3829 21.2888 -10.2051 -4.79955 -3.81503 -9100 4 24.4947 36.4635 22.1668 10.8854 5.06826 1.45383 -9101 4 25.816 36.6689 21.3407 0.621807 2.11968 6.76072 -9102 6 31.8152 24.7333 2.44905 16.2387 18.0677 -0.666362 -9103 4 31.5926 23.846 2.71622 -2.49338 -12.6998 4.18613 -9104 4 32.794 24.7683 2.43834 -16.3068 -2.39725 -1.0987 -9105 6 24.1315 21.9864 37.2328 -11.9778 41.7246 15.7453 -9106 4 24.1531 22.9879 37.1682 1.73438 -35.6656 2.36813 -9107 4 24.6319 21.6756 36.4808 8.45953 -1.72708 -12.6617 -9108 6 37.1993 11.5451 15.0492 16.5469 7.10484 -0.527568 -9109 4 37.9299 11.7412 15.6355 19.6925 -10.3737 -3.43176 -9110 4 36.5282 11.9944 15.5291 -36.4248 10.8574 4.75341 -9111 6 36.4804 20.3298 41.7865 -14.7619 -38.0306 11.4639 -9112 4 36.2972 19.4996 41.306 -2.7681 3.32899 7.9346 -9113 4 36.9128 20.8369 41.1399 19.1888 26.5648 -23.5244 -9114 6 32.0378 37.9251 32.6621 -20.5074 -27.3147 -8.21436 -9115 4 32.5159 38.6908 32.9558 4.48721 20.2349 -0.22713 -9116 4 31.3298 38.1855 32.0457 8.6638 5.37323 8.26506 -9117 6 12.0353 39.9275 22.5179 -19.9222 21.97 13.043 -9118 4 12.3148 40.8142 22.1582 -9.65836 -22.9721 12.3921 -9119 4 11.2968 40.0749 23.1753 26.4497 -1.81786 -22.4595 -9120 6 26.3421 1.33641 19.2861 18.8224 -12.0939 15.9617 -9121 4 26.8564 0.711595 19.8557 -14.3211 16.2919 -14.6989 -9122 4 26.7977 2.18849 19.3545 -2.53714 -0.144297 -3.51109 -9123 6 5.91333 14.3058 5.68279 5.58536 -17.6781 -26.1831 -9124 4 6.35226 14.1008 4.80839 -10.2521 5.5819 21.3359 -9125 4 5.1498 13.7016 5.72209 7.95548 1.62414 0.442017 -9126 6 13.3681 23.0924 19.1542 -7.87238 10.4677 13.234 -9127 4 14.1204 22.8148 18.6592 15.6827 -8.39443 -13.4152 -9128 4 13.7622 23.5769 19.9007 -5.90355 -3.89356 -3.96922 -9129 6 23.3981 15.0775 9.7431 -16.2896 3.15659 0.0853289 -9130 4 22.5416 14.6758 9.94236 4.38356 -3.66538 1.71341 -9131 4 23.1926 15.7004 9.03099 5.43777 4.93098 -2.67512 -9132 6 49.5886 13.8369 18.4468 -1.57371 0.160736 10.1606 -9133 4 48.8725 13.4353 17.9701 -17.3578 -11.6866 0.338485 -9134 4 50.0711 14.2256 17.7358 20.2332 17.1818 -14.445 -9135 6 41.7455 5.66741 41.8995 19.0031 1.14603 7.86728 -9136 4 42.5946 5.93333 0.438032 -19.5636 -6.95293 -12.6597 -9137 4 41.9891 5.05837 41.1762 -2.65724 5.24908 4.18535 -9138 6 17.2511 35.5417 2.55548 5.2045 0.397579 1.12894 -9139 4 18.2067 35.619 2.48098 6.39755 9.05508 3.07921 -9140 4 17.0886 34.6316 2.34229 -4.27489 -11.2961 -3.02567 -9141 6 49.7041 19.8589 40.2412 43.8428 -27.8149 3.09893 -9142 4 49.318 19.0163 40.5437 -5.31641 8.5833 -2.14336 -9143 4 50.6864 19.6533 40.2493 -27.6084 12.6334 -3.24012 -9144 6 38.3071 5.82731 32.0534 -20.9946 -3.84451 12.3853 -9145 4 37.8352 6.48986 32.6009 6.6943 -7.79079 -6.23381 -9146 4 39.2094 6.1245 32.003 13.4939 6.60324 0.292563 -9147 6 16.2694 6.84865 34.0054 -5.49782 1.82896 8.85162 -9148 4 16.5828 6.71308 33.1028 9.77351 -3.29618 -0.21352 -9149 4 16.9894 6.61948 34.6288 -2.86373 0.259786 -9.19674 -9150 6 33.6805 18.2019 10.4544 40.2358 -26.4835 -11.4715 -9151 4 34.2537 18.8203 9.96489 -9.74865 -7.15313 7.53482 -9152 4 34.2179 17.3378 10.5117 -27.819 38.8859 -1.78852 -9153 6 38.8962 33.7675 36.7566 23.6769 3.34821 -39.6603 -9154 4 38.383 33.5793 35.9171 9.63189 4.7017 21.543 -9155 4 39.855 33.8637 36.4612 -29.1237 -5.01255 9.39617 -9156 6 45.367 13.0954 20.2202 -17.4715 7.54819 27.7127 -9157 4 45.262 12.6289 19.4029 4.78427 -8.6457 -19.3619 -9158 4 44.4728 13.0498 20.6095 8.33403 2.77458 -3.46579 -9159 6 36.394 32.2025 8.83838 -5.39961 -0.779561 10.8196 -9160 4 36.3766 31.4559 9.45045 4.37642 -0.919546 -0.394048 -9161 4 35.9671 32.9207 9.33542 2.20851 -0.984819 -7.57369 -9162 6 7.93081 27.8143 6.16526 -1.31132 8.47671 -18.7581 -9163 4 8.2701 27.2941 6.88743 5.87236 -5.84072 6.56369 -9164 4 8.18271 28.7096 6.41539 -7.71007 1.94397 -1.55613 -9165 6 14.2797 4.87717 33.6823 -38.1616 11.9775 -32.0892 -9166 4 13.6477 5.2447 32.9846 23.9092 -16.4836 27.177 -9167 4 14.8408 5.63056 33.8658 12.4601 7.15131 6.13949 -9168 6 12.2578 8.65243 9.85848 -4.82715 -2.24662 -5.48477 -9169 4 12.6456 8.73928 10.7118 23.7259 9.48722 19.5525 -9170 4 11.4378 8.2214 10.089 -13.622 -8.47682 -13.9839 -9171 6 29.7261 31.9842 8.54243 -17.2145 25.3825 -18.7463 -9172 4 30.1804 31.833 9.34913 11.7892 -12.8324 21.9258 -9173 4 29.6399 31.1708 8.03663 5.85846 -6.51984 4.51241 -9174 6 22.3891 10.8785 21.4662 8.73739 -5.18702 6.55753 -9175 4 21.8037 11.1386 20.7714 -14.2177 0.338512 -24.4291 -9176 4 22.2091 11.5521 22.1168 2.36988 5.22793 14.1218 -9177 6 54.1797 27.5396 12.9955 26.3988 -18.3584 17.6139 -9178 4 0.160041 27.5787 13.0909 -6.71045 -5.06664 4.99497 -9179 4 53.9798 28.2721 12.4475 -15.7222 27.4826 -22.0497 -9180 6 7.71973 13.812 20.0407 -34.9077 17.0186 -30.9147 -9181 4 8.32362 14.1503 20.6766 20.1403 8.526 22.156 -9182 4 7.35968 14.6399 19.6101 8.73645 -26.5601 8.16532 -9183 6 19.7932 0.841243 24.7869 -1.21084 18.2021 12.2367 -9184 4 19.1669 1.06895 25.5104 7.86649 -0.445713 -11.3386 -9185 4 20.4073 1.61074 24.7031 -15.4775 -18.2332 3.4978 -9186 6 3.01312 10.0986 2.94829 -27.2997 12.089 -8.88269 -9187 4 2.52802 10.9508 2.83041 12.1807 -20.5661 3.67701 -9188 4 3.91304 10.3154 3.17839 17.025 6.36995 4.07131 -9189 6 15.8857 13.0124 24.0049 15.5529 -4.67501 -5.43243 -9190 4 15.0856 13.5308 24.0834 -5.13718 6.9751 3.63726 -9191 4 16.3233 13.139 24.8614 0.105722 -2.17465 -3.852 -9192 6 17.0852 4.33969 26.9167 21.5143 -4.09641 1.48348 -9193 4 16.9912 4.27513 25.9666 -0.355278 1.74978 -10.9716 -9194 4 18.0601 4.31538 27.0472 -16.9044 3.21714 1.83131 -9195 6 33.6168 39.4091 10.6433 -2.74936 14.5855 -32.8438 -9196 4 33.9454 38.5625 10.8616 8.60753 -33.4012 17.9817 -9197 4 33.8375 39.4354 9.68976 -8.01757 16.2593 11.171 -9198 6 36.2326 1.10755 13.0941 -10.1125 -3.31802 -5.56412 -9199 4 35.6506 0.392496 13.3579 -10.7819 -8.26966 -9.36682 -9200 4 36.7599 1.20112 13.8707 17.1874 9.72194 12.3054 -9201 6 40.862 19.2925 5.11158 -0.402197 -15.9333 44.5432 -9202 4 40.3871 19.4968 4.34679 -15.032 12.6888 -52.1674 -9203 4 40.1189 19.1611 5.72143 13.4548 0.976419 10.4775 -9204 6 2.35452 37.5497 10.1778 32.5589 0.132829 19.8916 -9205 4 3.04634 37.0953 10.7141 -10.4583 9.64478 -9.40166 -9206 4 1.85979 36.8581 9.75685 -15.4906 -16.9123 -13.0897 -9207 6 8.10293 29.0334 15.8847 29.3895 -23.7333 0.542295 -9208 4 9.03551 28.6824 15.7668 -29.6945 17.5799 0.572456 -9209 4 8.18484 29.8326 16.4072 3.85606 5.10463 3.42896 -9210 6 47.3132 26.514 12.5427 4.56821 28.1849 -37.0073 -9211 4 47.5111 27.2634 11.8891 -8.56493 -28.9528 31.2783 -9212 4 47.3519 25.7475 11.9556 -1.34676 -3.33794 4.54904 -9213 6 33.5886 17.4994 0.666432 -7.15301 -2.01744 8.51284 -9214 4 32.6196 17.5968 0.930917 31.8637 -19.8727 -7.43903 -9215 4 33.9404 16.5735 0.747207 -21.2256 15.6146 2.50609 -9216 6 38.9757 15.6004 36.3686 4.31005 -11.6982 -11.4703 -9217 4 39.1719 14.652 36.4294 -3.02079 4.3409 1.02949 -9218 4 39.3764 15.8813 35.5317 -1.53099 5.14915 -0.246696 -9219 6 34.8198 34.351 9.37266 2.46578 -22.7668 -16.8875 -9220 4 35.3506 35.0289 8.96724 14.9634 11.0695 -15.2613 -9221 4 34.4558 34.8191 10.0913 -19.5236 18.4179 34.8179 -9222 6 44.9681 2.58102 14.7874 21.8703 21.498 2.75759 -9223 4 44.0383 2.44896 14.9383 -16.9502 -5.72583 1.77575 -9224 4 45.1679 3.47323 15.1264 -3.49788 -5.23458 -3.46791 -9225 6 42.6138 38.2902 19.8325 18.6047 12.1973 -29.2276 -9226 4 42.7029 39.1598 19.3445 -0.0117609 -27.8329 13.7468 -9227 4 43.0921 37.6383 19.2425 -13.1736 20.1758 17.0781 -9228 6 18.6869 26.7647 30.2619 -33.6624 -6.012 -17.6355 -9229 4 18.1258 26.7596 29.445 14.3051 -0.674317 21.614 -9230 4 19.5687 26.9499 29.9621 19.5047 4.84041 -5.57389 -9231 6 38.8661 37.7421 16.4836 -9.78438 -6.51051 7.80135 -9232 4 38.7478 36.8102 16.2377 -7.01003 6.44463 1.75037 -9233 4 39.8105 37.8446 16.5724 18.1337 5.4462 2.51551 -9234 6 49.3017 9.82081 12.5377 12.9664 18.8416 30.0962 -9235 4 48.8085 9.39111 11.8826 -17.6666 -23.7062 -38.8329 -9236 4 48.5984 10.2345 13.0427 4.42646 9.01279 7.79627 -9237 6 43.2246 7.36268 19.8264 -1.99344 11.167 24.993 -9238 4 42.5572 7.81175 20.4051 12.7818 -10.9207 -14.0727 -9239 4 44.1025 7.51179 20.2375 -5.96789 -3.6213 -7.06723 -9240 6 36.3461 38.714 4.42821 -2.77728 9.11116 8.98737 -9241 4 36.8002 39.5234 4.70824 5.05063 -6.10698 -1.49424 -9242 4 35.4394 38.9016 4.68929 -3.84434 -7.68842 -3.54296 -9243 6 27.8 17.802 15.105 0.992317 -7.44098 -8.78046 -9244 4 27.5393 16.935 14.729 3.58787 16.6938 2.50389 -9245 4 27.8517 17.6781 16.0585 0.147204 -0.130556 3.13955 -9246 6 18.0837 3.77506 37.3201 -10.3169 -12.5791 -10.2966 -9247 4 18.6663 3.07474 37.0146 -2.03685 -5.25132 -4.70316 -9248 4 18.6637 4.19691 37.9324 10.4473 20.1285 21.3871 -9249 6 7.71395 11.575 6.52222 6.59834 -21.2687 20.1659 -9250 4 7.75955 12.4254 6.93969 -0.705235 13.257 9.50392 -9251 4 7.66936 11.739 5.5978 -3.42683 1.36071 -31.338 -9252 6 31.4909 14.3449 18.0451 -1.46982 -12.276 17.176 -9253 4 32.1287 14.6507 17.397 7.38292 5.65775 -7.44504 -9254 4 32.0331 13.8785 18.7146 -6.90734 4.25576 -5.30331 -9255 6 50.3346 30.4143 8.91505 10.1635 2.25064 -1.90936 -9256 4 49.6557 30.853 8.39615 -4.47176 4.28708 -1.87566 -9257 4 50.0231 29.531 9.11356 -2.73977 -1.84009 2.34474 -9258 6 42.1686 10.1057 12.759 16.2008 2.03437 -4.20809 -9259 4 41.2649 9.83209 12.6487 -17.4225 -8.81494 -4.74081 -9260 4 42.1292 10.8861 13.3105 -1.28453 5.18814 5.66853 -9261 6 37.773 3.09539 32.5582 -5.24906 4.78867 -2.39206 -9262 4 38.0736 3.99724 32.5969 21.7942 11.3719 -4.3192 -9263 4 36.8519 3.25822 32.7463 -19.4678 -11.9252 3.55114 -9264 6 35.7586 13.1005 19.2721 9.99017 -22.7528 0.0781354 -9265 4 36.1308 13.8223 19.7887 2.26592 2.2719 5.61144 -9266 4 36.2509 12.2915 19.5517 -9.66412 15.3645 -2.5809 -9267 6 45.5318 4.12684 21.4944 7.1153 -16.224 0.922187 -9268 4 45.5588 4.23252 20.5315 -1.8039 6.94223 3.67507 -9269 4 45.7548 3.18328 21.6122 -5.15542 13.2346 -0.821742 -9270 6 16.876 1.8608 31.4782 -3.84426 -17.9183 -35.0426 -9271 4 16.0621 2.17388 31.0004 15.6258 0.929179 27.3362 -9272 4 17.1381 2.25043 32.3174 -12.6393 14.1325 4.42374 -9273 6 14.0947 4.88307 23.5769 -10.6061 -28.6131 16.0669 -9274 4 13.8059 5.76888 23.7237 -2.25817 32.588 -6.82267 -9275 4 13.6039 4.42137 24.2892 9.04813 -2.88937 -11.9208 -9276 6 38.3208 33.7635 12.3625 -16.3318 -7.70706 -26.0192 -9277 4 38.1373 32.9408 11.8506 0.297782 14.7405 12.2413 -9278 4 39.1486 33.6221 12.8093 16.0136 -1.39994 11.7584 -9279 6 35.6849 3.05753 37.6719 3.72695 1.1389 -16.7638 -9280 4 35.1101 2.5063 38.212 -4.0587 0.687226 6.19097 -9281 4 35.8854 3.87289 38.1447 -1.86413 5.08658 8.8135 -9282 6 31.3385 37.395 35.3723 -12.2239 -8.91609 34.0312 -9283 4 32.2231 37.7249 35.5382 9.93962 6.70229 -3.55138 -9284 4 31.225 37.4524 34.4409 4.86335 0.993516 -31.3389 -9285 6 52.0614 11.7324 14.0182 20.1458 -4.7001 -39.6215 -9286 4 52.0268 11.0667 13.2735 0.495691 14.4049 24.809 -9287 4 52.7095 12.4171 13.7023 -24.8081 -17.2766 13.6147 -9288 6 26.3478 3.42613 41.0189 1.80794 1.58056 -19.374 -9289 4 25.6151 4.01507 40.9203 -25.7718 5.99951 16.8165 -9290 4 26.7914 3.68675 40.2055 22.5797 -12.3384 -0.204994 -9291 6 24.3802 34.9453 11.1613 28.8325 38.7039 -6.19962 -9292 4 24.3515 34.6784 12.0652 -4.50215 -14.1529 28.2178 -9293 4 23.9023 34.3202 10.6558 -20.492 -31.6724 -14.1682 -9294 6 32.0094 7.59293 31.2147 -3.26399 8.81733 5.62682 -9295 4 32.0976 7.47613 30.2777 2.1706 -0.778595 -17.1478 -9296 4 31.5266 8.43606 31.2858 0.565291 -7.84955 4.65821 -9297 6 28.7282 2.60805 0.424377 -15.1279 1.50585 -5.39222 -9298 4 29.2952 2.36387 41.5859 -5.33248 3.35197 5.42737 -9299 4 27.7901 2.65331 0.119401 23.4632 0.0509354 2.06419 -9300 6 42.125 19.2126 9.86039 10.7783 -7.26578 33.4177 -9301 4 42.6695 19.2101 10.7019 -20.1092 0.869002 -30.5597 -9302 4 41.4363 18.5278 9.96356 3.48727 6.10561 -4.25932 -9303 6 33.0194 27.0842 8.32851 16.6372 -6.55357 -10.7525 -9304 4 33.8911 27.0001 7.90493 -7.38323 -0.765342 -2.5624 -9305 4 33.2437 27.3744 9.20899 -0.425855 7.33259 11.2137 -9306 6 4.16433 8.30018 19.1575 16.0783 -2.51395 5.95143 -9307 4 4.71165 7.98099 18.3991 -19.3854 5.29846 8.38252 -9308 4 3.22273 8.32359 18.9288 3.05712 -5.28108 -12.2975 -9309 6 20.7745 29.1912 37.0609 -25.9123 -20.3491 -5.83769 -9310 4 21.0713 28.277 37.0594 -15.1664 -12.7508 0.5123 -9311 4 21.6013 29.5933 37.1743 32.957 35.4267 8.73191 -9312 6 13.1089 4.99809 10.9103 2.80775 13.1965 -7.17841 -9313 4 13.4591 5.85092 11.2415 -2.5949 -14.1267 -1.88178 -9314 4 12.7051 5.16456 10.0462 -1.2434 3.82389 2.90473 -9315 6 37.5087 18.1031 32.5343 20.0502 31.699 14.1692 -9316 4 38.1018 18.8164 32.1735 -18.2411 -21.7333 4.56216 -9317 4 37.2041 18.4813 33.3903 1.90105 -7.17599 -12.7275 -9318 6 17.7655 33.2839 30.7231 12.9967 19.9173 -17.9311 -9319 4 17.8488 34.0437 30.1253 -3.68331 -4.50715 1.49576 -9320 4 18.5638 33.345 31.2563 4.57995 -0.934488 4.72964 -9321 6 23.1969 32.7832 9.90135 2.14033 10.4984 -5.43395 -9322 4 23.4737 31.9362 10.2634 3.28964 -4.66398 1.33779 -9323 4 22.2469 32.7196 9.72631 0.753558 0.42269 -0.434072 -9324 6 14.8911 9.35828 34.246 -8.54616 0.784134 0.501674 -9325 4 15.4672 8.59016 34.1372 5.2294 -0.0873347 -3.8795 -9326 4 15.23 10.0905 33.7027 2.53244 -1.05206 0.202563 -9327 6 31.1203 39.3599 38.5719 4.30147 -17.578 8.21172 -9328 4 31.5941 38.6377 39.0527 -10.1026 17.4492 -9.05875 -9329 4 30.4019 38.9077 38.1077 1.84332 2.82409 1.03593 -9330 6 5.29005 34.4279 28.2716 -0.764315 -10.945 -9.90403 -9331 4 5.24266 35.3772 28.447 -0.427568 -2.02335 -2.15628 -9332 4 5.18384 34.3192 27.3143 2.05225 4.04935 9.99949 -9333 6 30.3216 21.6974 14.1256 3.24994 1.03129 -0.468005 -9334 4 30.4656 20.7696 14.235 0.884625 -14.9253 16.053 -9335 4 30.3519 21.7638 13.1772 -0.963709 16.3006 -15.7103 -9336 6 23.8542 39.0018 28.2919 38.6077 23.8437 -8.99828 -9337 4 23.8505 39.6937 27.6143 9.44649 3.56781 3.51793 -9338 4 23.0185 38.6309 28.1896 -50.029 -28.3524 0.952356 -9339 6 9.61332 13.5451 16.4567 13.7131 10.5156 -25.323 -9340 4 8.77595 13.0917 16.3907 -9.93448 -5.52821 8.41851 -9341 4 9.74204 13.8378 15.5322 5.69689 -3.544 12.5309 -9342 6 25.9753 6.18174 15.7989 23.4837 -9.67411 23.9067 -9343 4 26.0218 6.10484 14.8454 5.11216 -1.95092 -7.71856 -9344 4 26.7445 5.66727 16.1761 -27.6477 18.1551 -17.3833 -9345 6 15.9921 33.6419 22.5616 2.25497 8.86036 -26.9911 -9346 4 16.0049 34.0594 21.6804 -4.22455 0.568633 15.0409 -9347 4 16.1032 32.7157 22.281 -1.05219 8.42244 16.6761 -9348 6 40.6812 13.5416 12.1266 -4.5396 -12.3661 6.74099 -9349 4 40.4134 12.947 11.4149 -4.75912 -2.4644 -8.17888 -9350 4 41.058 12.9332 12.7776 -0.386087 8.79442 1.8157 -9351 6 35.5875 40.2809 31.6993 12.2791 -13.6127 -29.8257 -9352 4 35.948 40.913 31.0681 -4.17713 12.2213 7.17402 -9353 4 35.6271 39.4709 31.1475 -9.59473 3.36029 20.1077 -9354 6 19.3493 17.5927 17.849 24.123 48.8902 3.26857 -9355 4 19.9577 18.423 17.9915 -34.5112 -38.8316 -9.06029 -9356 4 18.6928 17.806 17.1645 6.15508 1.01267 5.31501 -9357 6 7.96541 28.082 10.7737 20.0283 17.3944 8.50509 -9358 4 8.43659 28.8341 11.2297 -13.1431 -15.7733 -11.3814 -9359 4 7.20109 28.4458 10.3015 -0.215648 4.06143 0.688545 -9360 6 32.1489 39.5869 16.6475 -7.37335 1.81146 -4.92627 -9361 4 31.705 40.4043 16.3332 3.90743 -15.5774 4.53996 -9362 4 31.4977 38.8659 16.5723 3.01217 10.596 3.08762 -9363 6 35.8095 2.63602 18.127 2.07542 -14.8225 4.13142 -9364 4 34.8947 2.32962 18.1713 7.15775 -3.6283 3.09768 -9365 4 35.7135 3.4873 17.7367 2.81673 20.5762 -11.5045 -9366 6 14.9588 39.9585 36.8943 -2.86001 -28.3727 24.0409 -9367 4 15.4545 39.4909 36.2335 10.0689 -8.68258 -13.459 -9368 4 15.0094 40.8569 36.655 2.72867 44.443 -9.08423 -9369 6 18.3115 32.3916 11.4639 8.59274 12.4423 14.7113 -9370 4 18.6438 32.5881 12.3772 -9.2478 -5.5834 -23.9484 -9371 4 17.8762 33.212 11.1576 6.35145 -13.5457 0.164794 -9372 6 14.605 10.3819 4.99774 5.57597 -6.68493 12.6773 -9373 4 13.677 10.4388 4.75284 -6.10435 1.24571 -3.75468 -9374 4 14.6185 10.047 5.91478 4.2493 4.0336 -10.9734 -9375 6 2.02851 14.3408 39.1627 -4.03313 12.5981 -1.48522 -9376 4 2.74992 15.009 39.2086 -14.5088 -8.45155 5.07373 -9377 4 1.21458 14.679 39.6124 19.1623 -3.42757 -8.41789 -9378 6 7.58709 14.1522 32.4651 10.4977 19.6861 -0.504887 -9379 4 6.93593 13.6605 32.9674 -3.57672 2.30039 3.8359 -9380 4 7.5987 15.0834 32.797 -1.90079 -22.9019 -5.87851 -9381 6 6.15309 23.123 37.664 -26.7168 -14.8188 -11.2926 -9382 4 6.52639 23.9838 37.7378 17.5333 20.6862 9.20416 -9383 4 5.45539 23.2608 36.9958 8.40974 -10.7335 8.81374 -9384 6 37.3009 22.5422 4.44282 21.6187 66.9857 0.670839 -9385 4 36.5208 22.1217 4.15693 -30.5217 -23.5005 -12.8181 -9386 4 37.1232 23.5227 4.23696 10.5274 -41.8214 11.62 -9387 6 47.1349 31.0113 5.88613 -14.3653 5.64202 -58.02 -9388 4 46.9542 30.9019 6.7933 -9.29323 -2.10558 39.1512 -9389 4 46.2627 31.2059 5.44524 20.5013 -7.22248 10.5418 -9390 6 54.8094 25.5909 34.9286 -5.37395 41.5808 12.672 -9391 4 54.0266 25.5089 35.4943 -0.981006 -11.4098 -6.26775 -9392 4 0.0616925 26.543 35.1263 -1.5494 -32.4448 -11.2369 -9393 6 37.1551 2.08197 4.79239 -12.5712 23.0197 -22.5278 -9394 4 36.5844 2.86136 4.61445 9.59981 -14.8952 -2.62483 -9395 4 37.0798 1.96202 5.72873 2.5296 -7.23911 19.6989 -9396 6 22.5239 28.6012 8.91155 -7.98869 19.6075 21.4366 -9397 4 22.8946 28.4124 9.79991 -0.853296 -5.89568 -17.4096 -9398 4 22.801 27.9767 8.25343 10.1708 -14.6558 -3.7409 -9399 6 8.64208 27.1509 24.5664 -38.2161 25.5543 4.78276 -9400 4 7.71753 26.8887 24.5582 -5.16372 11.0804 -0.386298 -9401 4 9.04357 26.3309 24.4724 40.7169 -47.477 -5.23592 -9402 6 1.14997 23.727 2.4309 6.46058 8.65979 -14.8341 -9403 4 1.18232 23.9936 1.48373 -6.63581 -4.99587 16.5657 -9404 4 0.310199 23.2733 2.54924 -0.981545 -0.950126 -1.89037 -9405 6 54.3702 30.2259 27.0243 -0.035121 6.58363 -4.50453 -9406 4 54.2615 29.4654 26.4339 1.23903 8.74071 -4.24792 -9407 4 54.6064 30.9974 26.4582 -3.83852 -12.4126 5.30421 -9408 6 0.386829 8.42023 23.9938 5.00922 -16.8445 -6.80376 -9409 4 1.36083 8.4508 24.0758 -8.17173 1.21512 3.08891 -9410 4 54.9524 8.88826 24.7258 9.13745 3.54566 6.13736 -9411 6 16.8971 28.5839 33.3722 23.8511 -30.9569 -4.46587 -9412 4 17.442 28.7831 34.1436 -6.82268 9.96305 3.46007 -9413 4 17.4403 27.8723 32.949 -23.4552 19.8179 6.40974 -9414 6 33.6969 30.8931 0.141175 14.1795 0.777253 -0.635822 -9415 4 34.6278 30.5945 0.162696 -6.8513 6.78484 1.91826 -9416 4 33.3211 30.3583 41.3463 -2.66034 -4.05802 -0.0970656 -9417 6 16.2525 21.5202 34.1552 3.2099 -15.0674 -0.387853 -9418 4 16.0099 20.7546 33.5903 4.90739 13.2878 5.87792 -9419 4 16.6977 21.1376 34.9376 -8.96682 7.2262 -10.6242 -9420 6 0.22977 17.7868 35.7492 -9.57638 -14.7124 1.37696 -9421 4 54.2434 17.9569 35.6827 28.6901 -4.22084 5.11773 -9422 4 0.351694 16.93 36.209 -4.1051 13.1178 -5.65765 -9423 6 16.8289 12.2962 0.019427 11.8958 12.8939 11.6481 -9424 4 17.3016 12.8498 0.703368 -12.3262 -21.137 -14.7379 -9425 4 16.4403 11.4936 0.411486 1.39397 8.07719 2.11333 -9426 6 8.24246 9.54397 36.2629 -25.8472 21.2414 2.40819 -9427 4 7.81464 8.9356 36.8788 1.26461 -2.06425 2.56422 -9428 4 7.48979 10.0869 35.9067 16.4576 -8.29365 1.86334 -9429 6 48.5761 26.718 39.8382 -16.8767 -13.2223 25.9758 -9430 4 48.2189 26.9037 38.9774 0.202946 6.43929 -15.4249 -9431 4 49.4865 26.9849 39.8847 17.129 6.93076 -9.10183 -9432 6 35.4777 1.07865 23.1156 20.3084 9.46551 28.8556 -9433 4 36.0215 1.72656 22.6213 -7.75205 -10.5654 8.45632 -9434 4 35.804 1.12911 24.09 -10.3378 -1.68949 -45.1242 -9435 6 20.2777 30.6326 19.3782 17.168 -16.4055 9.77372 -9436 4 20.2499 31.0311 20.2788 1.56461 -6.55175 -10.0354 -9437 4 20.938 29.881 19.3855 -20.6701 22.3694 2.2449 -9438 6 44.3702 15.9458 1.58361 10.9348 22.193 31.2112 -9439 4 44.4077 15.6379 2.51116 -1.71559 -1.42871 -18.164 -9440 4 44.6431 16.8967 1.66823 -9.97295 -22.8516 -13.6111 -9441 6 53.8845 34.4651 10.6068 -24.0145 7.95167 -19.3224 -9442 4 54.4361 34.2696 11.3314 22.7066 -9.19703 33.7305 -9443 4 54.2985 35.2035 10.1555 0.2437 -1.83103 1.50375 -9444 6 46.1364 32.8471 33.519 4.96533 -12.2334 2.48444 -9445 4 45.9404 33.6629 33.0556 -3.66306 8.73713 -2.86335 -9446 4 47.0477 32.6179 33.2654 -4.26196 1.19291 1.09329 -9447 6 42.1324 21.9098 24.2239 34.4777 -24.9191 34.4505 -9448 4 43.0412 21.5159 24.3646 -28.4667 14.3091 -11.1056 -9449 4 41.7437 21.6811 25.0949 -3.80951 9.2794 -19.6729 -9450 6 8.14185 3.89847 11.6387 2.30661 -15.3192 6.95264 -9451 4 7.35197 4.1174 12.1322 -8.99547 12.8437 -2.29886 -9452 4 8.35392 3.05748 12.0535 10.9023 -1.5691 -3.31016 -9453 6 19.6413 41.6808 9.8267 1.07442 6.29255 0.337359 -9454 4 18.9204 41.094 9.57509 0.414049 2.67892 1.92063 -9455 4 19.352 0.205183 10.6506 0.427822 -12.2572 -10.0953 -9456 6 42.3157 8.41085 31.6785 13.3628 11.5473 -7.23952 -9457 4 41.3969 8.42848 31.9417 -9.73605 -1.80426 0.915182 -9458 4 42.5534 9.35818 31.5624 -0.333442 -16.319 1.99913 -9459 6 26.911 16.154 25.3637 -0.10907 13.2502 -20.6653 -9460 4 26.7939 15.8861 24.4207 -0.565005 2.37017 21.4763 -9461 4 26.6835 15.4121 25.9182 -3.52016 -12.4926 6.14171 -9462 6 48.2345 6.48613 12.6212 -1.55264 -8.09911 -9.8466 -9463 4 48.9652 6.31914 12.0011 -5.93235 3.28214 2.19301 -9464 4 47.4516 6.10442 12.1764 7.36669 2.93589 5.65527 -9465 6 53.4556 41.5274 30.6561 0.928349 -3.66285 -10.4005 -9466 4 53.9738 41.8466 29.9077 -1.68735 -3.84443 -4.80087 -9467 4 53.7246 0.16796 31.3785 5.2081 5.34012 15.7103 -9468 6 47.0719 22.4215 31.8177 3.79963 28.0651 -15.4962 -9469 4 47.8542 22.5824 31.2379 -15.4047 -7.22606 14.7582 -9470 4 46.5391 23.2393 31.6689 5.43499 -22.2824 10.2038 -9471 6 19.5241 5.44646 15.2431 57.7261 9.00726 -25.1025 -9472 4 19.973 4.5781 15.2547 -6.4602 7.66804 1.10752 -9473 4 18.6769 5.33307 15.596 -47.9766 -8.78418 19.1468 -9474 6 14.6808 30.2445 33.392 16.954 11.9814 -17.0239 -9475 4 15.1668 30.8865 32.8123 -10.4914 -16.0898 10.6301 -9476 4 15.2553 29.4559 33.3904 -4.22445 9.80292 -0.52553 -9477 6 28.4427 24.2289 10.4187 -0.774793 -27.6212 -36.8967 -9478 4 29.277 24.4414 10.8128 10.21 14.4589 20.8069 -9479 4 27.7162 24.5027 10.9517 -9.91177 12.6254 22.5109 -9480 6 5.25429 14.4357 24.4952 18.8694 8.38265 -3.5804 -9481 4 4.38598 14.1455 24.6681 -43.369 -9.18674 12.4123 -9482 4 5.45154 13.9758 23.6794 9.52503 -2.95522 -10.1363 -9483 6 26.3476 19.2988 19.1857 11.4015 -18.2951 -12.5804 -9484 4 26.5417 20.1869 19.4853 3.52858 10.6793 1.31948 -9485 4 27.146 18.9308 18.7141 -21.2465 13.7562 17.259 -9486 6 28.5834 7.44603 13.1845 8.68409 29.8386 11.3246 -9487 4 28.3961 6.55455 12.9442 -2.45324 -19.0833 -9.20205 -9488 4 29.0571 7.89665 12.4686 -5.14786 -6.54739 -1.73865 -9489 6 5.35742 27.1473 37.0464 13.0843 -4.728 13.8292 -9490 4 6.09472 26.8663 37.6487 -17.7636 2.66278 -18.049 -9491 4 5.49884 28.0724 36.7882 1.93418 -3.90879 0.386893 -9492 6 53.1466 13.4128 16.1104 33.6732 -23.607 0.886679 -9493 4 54.0532 13.0537 15.8959 -24.4904 18.1541 2.55443 -9494 4 52.6056 12.6236 16.2807 -0.490038 10.6025 -2.0621 -9495 6 45.4595 1.03561 24.6152 0.883869 7.22473 8.82703 -9496 4 44.8005 0.912307 23.9218 -0.0838502 -1.3445 -1.23214 -9497 4 44.9845 0.757767 25.4168 6.19386 0.932014 -5.94613 -9498 6 50.1542 2.38642 13.9319 -2.4774 12.931 -1.3926 -9499 4 50.7815 2.76975 13.3044 0.014285 -4.08681 1.38242 -9500 4 49.5062 3.09016 14.0651 -1.63783 -0.639647 1.83323 -9501 6 19.5885 31.0175 39.1657 -10.9837 -21.6636 -18.6241 -9502 4 19.8079 30.3148 38.4832 -5.60324 21.7545 20.6111 -9503 4 18.6148 30.9453 39.3442 26.0441 2.6939 -5.02925 -9504 6 19.2491 14.7106 10.8907 20.9533 -11.5465 -13.087 -9505 4 20.0062 14.1954 10.4207 -44.2836 18.7066 28.5885 -9506 4 18.7045 14.0688 11.3882 14.1221 2.37282 -8.47947 -9507 6 4.44986 39.5549 20.1348 -7.46971 20.8744 22.4052 -9508 4 3.99116 40.4291 20.2667 12.3042 -22.0468 -4.08326 -9509 4 4.78876 39.261 21.0122 -11.398 5.88582 -21.7205 -9510 6 29.0264 13.3645 23.891 3.80322 20.0192 21.3715 -9511 4 28.7263 12.4558 23.8574 1.87437 -3.97007 -2.19356 -9512 4 28.9189 13.5991 24.8488 7.01015 0.856522 -27.3099 -9513 6 17.0674 2.76528 17.6511 13.6679 -9.88609 -24.0062 -9514 4 16.9089 3.43106 16.9566 -0.337692 -4.66999 2.92783 -9515 4 17.7694 2.16287 17.2836 -16.7881 13.7863 9.44417 -9516 6 43.472 18.0456 17.7207 2.90116 -6.00314 -10.3001 -9517 4 43.5328 17.0661 17.6262 0.602958 19.7978 9.46789 -9518 4 43.5843 18.2505 18.6627 0.176297 -8.32564 -1.3476 -9519 6 25.7838 40.7303 1.24723 -3.64329 26.5644 -28.0564 -9520 4 26.2198 41.3001 1.88369 1.46132 -2.86659 8.1156 -9521 4 25.5777 41.3986 0.532216 -2.57635 -28.6607 13.7824 -9522 6 0.458758 22.8928 6.22327 -2.28892 -3.37321 -2.62932 -9523 4 0.911995 22.0955 5.88137 -3.49653 6.37629 4.11618 -9524 4 1.15027 23.4262 6.63616 1.38998 -0.611711 -3.15133 -9525 6 26.2502 35.0072 18.629 11.2346 5.37396 -16.6635 -9526 4 25.9102 35.926 18.5821 -1.77201 -16.2127 4.61622 -9527 4 25.7094 34.5197 19.2578 -0.594129 4.22999 1.61862 -9528 6 16.1509 31.8837 7.54876 40.1408 -29.5169 -1.86921 -9529 4 16.9528 31.2446 7.38162 -38.5191 36.6879 6.5811 -9530 4 16.2422 32.6162 6.9246 8.25996 -4.45471 -3.71716 -9531 6 22.9569 16.8424 28.5503 -18.0144 15.9011 -12.9281 -9532 4 23.0242 16.0615 27.9964 2.65193 -8.47258 -0.731728 -9533 4 22.0914 17.2685 28.2981 23.9965 -14.5366 15.8079 -9534 6 48.817 29.3453 32.1483 10.2159 -3.67765 25.2301 -9535 4 47.913 29.23 31.8533 -10.4354 1.38436 -5.08298 -9536 4 48.8482 28.9579 33.0615 0.343667 8.53482 -20.1614 -9537 6 13.1275 24.857 5.54597 -15.7655 12.0094 -10.6158 -9538 4 12.8967 24.1126 4.95892 -3.19147 7.26676 2.83523 -9539 4 12.4206 25.5605 5.45199 17.9822 -22.1189 1.55356 -9540 6 10.967 20.7149 15.8389 3.49035 -8.57129 -4.90872 -9541 4 10.8232 20.5385 14.8814 6.84933 2.21154 19.4522 -9542 4 11.8211 20.2878 16.0966 -18.2767 7.30584 -13.8769 -9543 6 13.8574 18.376 6.9425 -18.5688 18.5302 -26.9748 -9544 4 14.0551 19.3329 6.99178 3.58444 -10.9562 5.12073 -9545 4 14.2751 17.8929 7.64202 12.8225 -6.30863 19.0643 -9546 6 13.8485 12.9413 30.6405 -7.33075 -24.1801 -9.47477 -9547 4 13.9233 12.3923 29.8469 14.5901 9.31788 -1.12157 -9548 4 13.0284 12.552 30.9634 -3.13873 11.8242 15.1361 -9549 6 17.1199 6.33729 31.2705 58.4108 60.4292 21.9502 -9550 4 16.7347 7.19592 31.0485 -2.55536 -2.82538 -1.05014 -9551 4 16.4932 5.72664 31.0455 -61.4006 -55.6776 -22.0804 -9552 6 7.63858 23.4232 20.5528 2.70849 -2.51933 -11.6338 -9553 4 7.34936 23.0623 19.6936 2.42656 1.66026 8.60009 -9554 4 8.06294 24.2698 20.3247 -2.54411 -7.58863 2.30144 -9555 6 15.6012 36.6828 25.6308 12.0382 0.865576 2.42327 -9556 4 16.546 36.4866 25.8589 -19.7129 13.5166 -7.57965 -9557 4 15.5566 37.5233 25.1245 15.7859 -9.47529 6.9914 -9558 6 0.738662 10.4099 22.1708 -26.6289 -22.4058 -14.7131 -9559 4 0.0268398 10.3645 21.4686 20.8647 0.21224 20.3485 -9560 4 0.555589 9.63254 22.7491 3.84168 18.0907 -12.5939 -9561 6 33.5034 17.3959 33.5951 21.201 30.6084 -13.4811 -9562 4 33.5895 18.3893 33.3705 0.776259 -45.1899 5.95193 -9563 4 34.1847 16.8766 33.1005 -9.04546 14.4589 8.38708 -9564 6 21.6622 19.013 20.7578 31.9274 -22.1518 -4.15649 -9565 4 22.4096 19.6032 20.9777 -11.5486 -3.71871 -1.82252 -9566 4 22.1307 18.1402 20.6082 -20.9219 25.304 3.1187 -9567 6 41.7583 19.992 16.8792 -6.68772 4.02339 -8.69865 -9568 4 42.2438 19.1637 16.9575 3.64207 -5.49479 0.617993 -9569 4 41.579 20.1273 15.9247 3.71595 -2.33609 11.0843 -9570 6 12.0355 14.9654 17.6922 -21.5841 1.26502 -18.8824 -9571 4 11.2182 14.5976 17.276 14.8021 5.3277 12.4216 -9572 4 12.4319 14.255 18.1907 -0.352973 -10.2116 7.98966 -9573 6 23.0172 11.4191 40.7206 -10.7217 24.0381 44.0704 -9574 4 22.9528 12.3236 41.1181 -0.480688 -24.3492 -4.33206 -9575 4 23.3445 11.5906 39.8675 15.3819 0.516123 -37.823 -9576 6 21.0055 28.3299 24.5595 -23.1154 26.0001 -7.02903 -9577 4 20.2855 28.1767 25.1713 -12.8069 16.7504 -3.2857 -9578 4 21.5564 27.6405 24.838 35.6802 -30.9994 4.41974 -9579 6 19.406 13.705 31.9364 14.5236 -8.57279 10.3452 -9580 4 18.7521 13.9469 31.2876 -5.81883 0.611034 -8.78432 -9581 4 18.9142 13.6788 32.7621 -0.186305 1.04404 6.29106 -9582 6 21.5918 2.86134 24.7058 -12.3779 12.1824 -8.79066 -9583 4 21.7274 3.16074 23.7816 9.4572 -7.89437 13.7797 -9584 4 22.4025 2.45534 25.0386 5.22934 2.42127 -4.70961 -9585 6 11.3487 29.9838 18.827 10.5554 -3.16976 4.47537 -9586 4 10.5352 30.5203 18.751 15.2364 -2.61973 2.60085 -9587 4 12.0043 30.4181 19.4217 -22.0541 -6.82347 -15.9561 -9588 6 14.6417 22.3529 8.3686 35.183 35.1516 7.4005 -9589 4 14.0314 23.0645 8.61446 -9.87113 -8.59651 0.991548 -9590 4 15.5117 22.8693 8.31218 -34.203 -30.7208 1.23805 -9591 6 43.9533 23.6664 17.2647 -9.15762 31.6597 -10.4885 -9592 4 44.7744 23.2846 16.9678 11.7125 -13.1472 -3.62648 -9593 4 43.5104 22.9908 17.7726 1.91474 -8.51607 6.21827 -9594 6 28.003 25.5014 27.4986 6.23457 -29.1533 -5.23677 -9595 4 27.4849 26.2827 27.5489 -17.6876 27.9136 1.36856 -9596 4 28.906 25.8001 27.3829 8.21911 6.89622 0.0845564 -9597 6 19.1046 26.8047 33.1413 12.2661 11.24 -48.0243 -9598 4 19.0365 26.4782 32.1917 1.11076 11.999 35.7369 -9599 4 19.4769 27.7251 33.0545 -9.7287 -23.6705 8.34301 -9600 6 6.37289 19.3428 5.67363 -3.21133 -16.2285 8.07537 -9601 4 6.7336 20.019 5.09886 3.22925 8.22387 -6.14542 -9602 4 5.58923 19.7346 6.08082 -0.796808 3.74051 2.3056 -9603 6 37.4835 28.3972 9.67963 -16.8252 8.64443 -22.9196 -9604 4 37.8384 28.0931 10.5154 1.79485 -10.7977 1.13655 -9605 4 37.3056 27.6421 9.07717 9.05958 5.47813 21.4583 -9606 6 17.6994 27.086 11.7957 -23.9049 -9.71644 -0.114793 -9607 4 16.9894 26.5877 11.2784 19.3807 18.9653 23.0761 -9608 4 17.3772 27.2467 12.7205 1.32974 -4.86863 -22.184 -9609 6 12.8804 1.95044 24.1635 -16.9081 23.6463 -41.3936 -9610 4 12.0123 2.42693 23.9788 24.6345 -20.1638 18.4271 -9611 4 12.9602 1.63912 25.0531 -11.2641 -4.9093 21.6908 -9612 6 27.8486 37.1249 33.3037 14.5525 0.843809 -12.8082 -9613 4 27.8306 37.7566 32.5563 -0.261378 -9.54721 11.1245 -9614 4 28.4641 36.389 33.0416 -14.495 18.5162 4.94281 -9615 6 18.6769 12.3657 6.31954 -0.243732 -29.9473 12.6257 -9616 4 18.5317 11.3932 6.23771 0.963018 17.4883 6.62231 -9617 4 18.5535 12.6707 5.42951 -3.51714 10.9469 -19.8301 -9618 6 10.1845 29.3127 24.783 -1.36331 5.89889 -4.08473 -9619 4 10.7465 29.1085 25.5662 -10.353 -5.60455 -9.55427 -9620 4 9.5047 28.6152 24.6271 17.6265 9.93184 12.3415 -9621 6 7.25219 3.30976 16.2618 16.5712 6.01323 38.0962 -9622 4 7.85224 3.92676 16.743 -7.28275 2.21025 -21.7569 -9623 4 7.07626 2.67339 16.9792 -0.839688 -3.96601 -21.0406 -9624 6 32.2032 37.556 1.10106 -1.45173 2.30566 -1.67736 -9625 4 31.7319 37.0242 1.72254 -12.3544 -30.6614 1.12887 -9626 4 32.1826 38.3533 1.61216 9.84976 31.1212 -1.90535 -9627 6 10.4132 10.1536 6.41547 2.6172 -5.66149 -5.23088 -9628 4 9.51094 10.4988 6.43252 -1.43241 7.72691 5.99088 -9629 4 10.888 10.4598 7.20926 -10.4429 3.02901 -4.20627 -9630 6 16.1922 23.2473 37.3836 13.4596 17.9231 -6.20094 -9631 4 16.4628 23.5362 38.2769 -1.8179 -2.41291 -6.91424 -9632 4 16.622 23.8878 36.7607 -9.68345 -13.0364 13.8052 -9633 6 24.0933 14.3373 36.5438 -0.810617 7.47513 6.008 -9634 4 25.0172 14.0983 36.6068 9.64822 -3.29568 0.232999 -9635 4 23.7283 14.0715 37.4031 -3.57511 2.15125 -3.19243 -9636 6 27.4694 18.5535 28.7878 -22.2405 -8.90967 9.68842 -9637 4 27.2463 18.155 29.6474 7.14424 4.94771 -10.1046 -9638 4 26.6163 18.5328 28.3045 10.7583 2.44378 -0.411902 -9639 6 51.5617 10.4928 1.56364 -46.044 -5.31617 -17.9438 -9640 4 50.711 10.1131 1.91707 23.1705 13.8427 -10.0979 -9641 4 52.2015 10.4284 2.24991 18.8641 -3.04547 25.194 -9642 6 31.1163 39.6073 27.5052 16.7753 -4.77526 -29.689 -9643 4 30.6203 39.2762 28.2489 -5.6675 10.9492 15.0474 -9644 4 31.3773 40.5466 27.6182 -8.67746 -20.5696 10.3555 -9645 6 6.90447 35.9666 14.3264 -30.1691 -4.34312 14.222 -9646 4 7.61578 36.3042 13.808 21.2575 5.14969 -9.00238 -9647 4 7.11482 35.0613 14.5906 3.01946 -0.973686 -2.74545 -9648 6 45.5514 7.57029 29.1841 -25.615 -5.69379 -2.02895 -9649 4 44.9198 7.51228 28.4263 15.6429 0.393509 16.1679 -9650 4 45.0848 7.11279 29.9186 7.09759 5.05324 -8.24334 -9651 6 31.3626 20.5603 31.6216 46.5235 7.85379 -13.5612 -9652 4 31.9622 21.3332 31.7077 -20.5518 -6.12612 6.97271 -9653 4 31.9328 19.9839 31.0823 -17.3109 -3.90007 7.28444 -9654 6 43.0286 31.1606 10.377 -16.6603 7.93207 28.9623 -9655 4 42.0878 30.8529 10.4887 24.119 8.07098 -2.29185 -9656 4 43.3099 31.4942 11.272 -6.72297 -13.7816 -28.1326 -9657 6 50.925 25.5606 12.6461 -27.6852 -6.08767 20.8539 -9658 4 50.917 26.3683 12.1731 -8.31821 35.0391 -16.2433 -9659 4 51.8024 25.2628 12.5325 34.7451 -18.8429 0.848912 -9660 6 29.3305 2.97987 3.64738 17.2649 -36.5424 -5.61333 -9661 4 29.6156 3.84373 3.86529 8.03017 35.8359 9.57326 -9662 4 28.4158 3.03535 3.41816 -23.9953 6.75187 -10.8335 -9663 6 53.9216 32.1051 20.3724 -11.2223 -0.478332 -4.16652 -9664 4 54.8523 32.157 20.1701 8.27859 1.2318 1.83366 -9665 4 53.5473 31.7256 19.5583 -4.88871 3.83013 8.11791 -9666 6 41.7036 29.5569 6.48267 17.2638 16.7804 -5.64052 -9667 4 40.7698 29.5903 6.27928 -11.16 5.83742 -3.44443 -9668 4 42.1548 30.305 5.99503 -16.5783 -19.3567 12.2041 -9669 6 37.8345 24.5719 39.3019 -13.0469 -9.65298 -3.86921 -9670 4 37.225 24.2046 38.6488 4.5791 4.74434 1.49749 -9671 4 37.4276 24.3068 40.1372 5.55374 4.45167 1.85829 -9672 6 46.5621 27.5658 23.2944 -23.9279 -33.0439 -11.1022 -9673 4 46.4387 27.4786 24.2739 -2.64996 -4.90603 -22.3791 -9674 4 45.938 26.8598 22.8442 32.7587 35.3455 32.269 -9675 6 9.23408 27.197 8.34767 -28.7607 6.82988 18.9345 -9676 4 8.89078 27.6282 9.16421 9.10203 -8.06063 -16.3167 -9677 4 10.1694 27.1106 8.44975 24.8451 0.83524 4.07321 -9678 6 36.0586 34.168 13.9947 0.546429 -20.5208 -0.995849 -9679 4 35.8317 33.2019 13.9926 1.47243 21.3574 0.844463 -9680 4 36.7518 34.2454 13.3214 -1.12661 -0.38848 2.20278 -9681 6 51.6812 14.492 12.3108 14.2062 7.57429 -10.7818 -9682 4 52.2015 14.4126 11.4771 -7.23407 7.45688 18.698 -9683 4 51.902 15.34 12.7416 -3.60656 -14.3916 -9.37264 -9684 6 15.248 19.6366 32.4109 27.4357 -16.6396 -20.9158 -9685 4 15.2931 19.2358 31.5053 -3.54534 7.22564 18.4797 -9686 4 14.3328 19.7639 32.5881 -28.0981 2.1384 2.91772 -9687 6 27.6849 24.6479 38.3573 2.41004 -14.3506 -18.7558 -9688 4 27.9256 25.2107 39.0738 -0.349992 17.1553 25.2623 -9689 4 28.4455 24.6938 37.7731 2.45273 -2.47407 -6.18841 -9690 6 37.5344 9.26205 13.6222 2.62805 -1.42602 2.92011 -9691 4 37.9029 8.73293 14.3466 0.897712 0.834078 0.0180659 -9692 4 37.323 10.115 14.0326 -0.799981 -1.44542 -1.10758 -9693 6 20.9013 33.2307 26.2512 6.46074 3.54373 3.40895 -9694 4 21.2661 33.4546 27.1222 -3.70394 5.03607 -5.2507 -9695 4 21.0534 32.294 26.1755 2.06129 -12.757 -1.69162 -9696 6 6.58179 13.9421 35.2385 -0.161437 -23.8226 2.06013 -9697 4 6.46846 12.9778 35.1898 -10.847 5.63462 -0.921172 -9698 4 7.53649 14.0007 35.2781 8.40152 11.229 1.63712 -9699 6 10.0736 7.47184 6.87074 6.29005 1.76204 -5.26249 -9700 4 9.16789 7.18556 6.66525 -0.124912 3.45645 -0.864518 -9701 4 10.1825 8.41968 6.63706 -5.90018 -13.0861 3.35766 -9702 6 31.1989 5.96627 11.4256 47.5137 28.7614 23.6553 -9703 4 31.4466 6.13876 12.388 -20.2952 -9.94335 -33.1747 -9704 4 32.0308 6.26994 10.9806 -22.1211 -12.2896 5.82222 -9705 6 12.1387 3.84993 35.2935 2.49551 -0.304387 23.4243 -9706 4 12.8187 4.19174 34.7257 10.4227 4.50872 -14.559 -9707 4 12.5185 4.00559 36.1769 -9.60543 -1.42105 -7.76228 -9708 6 5.33665 6.07757 27.6447 8.69228 -34.5823 40.5077 -9709 4 5.10952 6.83187 28.1919 -5.14709 12.9851 -0.252954 -9710 4 5.24124 6.31071 26.7545 -7.00092 22.4827 -45.3835 -9711 6 13.1372 33.5675 1.68451 12.1014 31.5323 -4.45098 -9712 4 12.5865 33.1501 1.03303 -8.81838 -7.47149 -8.20936 -9713 4 13.3352 34.4765 1.32576 -5.5291 -24.3721 14.4697 -9714 6 44.6567 10.4099 29.0319 -12.4525 3.56979 -21.9228 -9715 4 44.5737 9.45178 29.0051 9.95574 -3.72472 2.79876 -9716 4 44.0317 10.7133 28.332 10.7873 2.60441 13.9487 -9717 6 9.14585 24.5947 6.38022 15.9839 26.3438 -7.73853 -9718 4 8.92734 24.382 5.47582 -9.1117 -9.61509 -8.5024 -9719 4 9.72625 25.3768 6.21639 -5.50996 -10.1894 15.5503 -9720 6 52.5653 27.2618 21.6392 -6.48047 6.16108 13.4347 -9721 4 52.5564 26.3196 21.8908 4.78081 5.6644 -14.1528 -9722 4 52.8195 27.3969 20.7225 3.24319 -11.7343 -6.41363 -9723 6 7.29679 16.9603 33.544 -1.27463 2.76823 -11.9762 -9724 4 7.39152 17.7215 32.9493 2.03275 -0.910573 2.88066 -9725 4 6.37085 16.7082 33.4809 -4.66481 0.778096 -0.770576 -9726 6 43.9289 25.2227 7.97871 -4.96366 -10.0233 8.38699 -9727 4 43.2519 24.7308 8.49213 12.2574 5.67032 -8.3389 -9728 4 43.4276 25.9018 7.51862 -3.04483 5.5605 -3.23664 -9729 6 2.07953 27.1233 13.6028 0.0104954 7.16496 -8.77242 -9730 4 2.15896 26.2371 13.9627 -2.1358 -7.6126 6.04882 -9731 4 2.6502 27.1018 12.8141 -2.23666 2.89631 3.72058 -9732 6 37.3141 18.284 2.18477 -5.94753 -1.23785 7.60386 -9733 4 37.4961 17.5691 1.55591 -3.17432 -0.490531 -1.7774 -9734 4 36.7255 18.8979 1.7415 -3.03937 1.4219 -5.67571 -9735 6 25.0022 10.0655 0.429871 -30.1443 -7.37242 -0.593153 -9736 4 24.272 10.366 41.7528 14.2211 1.75124 5.05026 -9737 4 24.5705 9.40237 1.00583 14.7283 12.1051 -6.86513 diff --git a/examples/amoeba/dump.ubi.32.test b/examples/amoeba/dump.ubi.32.test deleted file mode 100644 index 743c5e68dc..0000000000 --- a/examples/amoeba/dump.ubi.32.test +++ /dev/null @@ -1,19492 +0,0 @@ -ITEM: TIMESTEP -0 -ITEM: NUMBER OF ATOMS -9737 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 5.4990000000000002e+01 -0.0000000000000000e+00 4.1909999999999997e+01 -0.0000000000000000e+00 4.1909999999999997e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 9.9631 5.60476 0.008413 6.29384 29.5246 19.0744 -2 2 9.59585 5.61686 40.5223 49.6095 -15.082 -19.7261 -3 2 8.19009 6.07902 40.3725 -38.3002 -36.0401 31.6494 -4 3 7.228 5.27674 40.5663 25.6537 34.3003 -15.2325 -5 4 9.24854 5.32486 0.671238 -4.4712 -3.37565 -7.28982 -6 4 10.3108 6.54317 0.309331 -11.8382 -28.5043 -8.77497 -7 4 10.7093 4.95217 0.170763 9.79439 -2.80927 4.02983 -8 4 10.3426 6.38567 40.0332 -19.5644 -29.2331 3.89265 -9 2 9.77742 4.13431 39.9813 -28.2245 -12.7597 2.79543 -10 2 9.48564 3.81758 38.4974 43.5672 -24.1926 -8.96475 -11 5 10.1176 2.11667 38.0047 -9.19737 11.9016 12.5734 -12 2 9.21456 1.10205 39.2112 31.2522 23.9396 11.6177 -13 4 8.99594 3.48122 40.5964 28.5446 19.8656 -13.413 -14 4 10.8136 3.75653 40.1807 -3.6049 4.77507 7.99264 -15 4 10.0744 4.47991 37.8007 -16.03 7.55553 14.4224 -16 4 8.42529 3.84402 38.2863 -20.8998 9.83371 -6.83213 -17 4 9.47601 1.46641 40.2263 -2.07893 -1.87234 0.341628 -18 4 9.53146 0.065851 39.1813 1.34892 -20.4385 -9.90461 -19 4 8.1577 1.22135 39.0727 -30.8502 -1.48556 -5.54631 -20 1 8.07565 7.408 40.3203 38.3461 4.68909 -14.5778 -21 2 6.84679 8.08521 40.1985 -59.0929 12.5985 8.76694 -22 2 6.18936 7.48414 38.9048 -11.7821 0.575019 41.3478 -23 3 6.7346 7.67531 37.8418 13.9355 0.826162 -41.115 -24 4 8.95137 7.92937 40.1018 -13.7432 5.12585 4.7357 -25 4 6.17099 7.78674 41.0889 17.7478 9.29385 -16.8634 -26 2 7.04543 9.68435 40.1788 6.06779 -36.4281 36.3417 -27 2 5.78315 10.5437 40.1541 10.0153 13.6856 -31.2349 -28 2 4.87823 10.4891 38.8981 8.0898 32.2503 -21.0798 -29 3 5.10035 11.2936 37.9551 -6.38068 -25.249 23.2549 -30 1 3.78765 9.69754 38.9447 7.74282 -10.5609 -2.0448 -31 4 7.77413 9.91905 39.4336 6.93206 10.4159 -38.5359 -32 4 7.65159 10.0279 41.0787 -15.5363 -12.6708 -2.68622 -33 4 6.21166 11.5927 40.0353 -14.0103 -9.11046 14.0038 -34 4 5.24199 10.4471 41.1154 -6.90019 6.03163 0.39253 -35 4 3.64982 9.13451 39.798 -8.63839 -3.4701 -4.98201 -36 4 3.18526 9.53497 38.0983 12.4509 11.2825 18.2671 -37 1 5.03649 6.76821 39.0271 29.2025 12.626 -49.9624 -38 2 4.1742 6.30537 37.9199 2.45922 -5.77224 11.4432 -39 2 2.7281 6.64357 38.2301 -33.27 13.9739 -28.2234 -40 3 2.48558 7.27851 39.247 -7.20167 1.94081 18.2399 -41 4 4.56901 6.92293 39.8729 -36.0812 -3.10094 47.9009 -42 4 4.41115 6.93099 37.0362 4.08063 -6.87028 -11.6053 -43 2 4.30896 4.77224 37.6863 5.60806 -34.2262 -10.7438 -44 2 3.61194 3.83713 38.7945 21.7291 41.8848 -7.6362 -45 2 5.81981 4.32753 37.5156 -0.302636 -10.5955 -12.2236 -46 2 3.74184 2.37563 38.4472 -21.3499 -20.7746 -35.862 -47 4 3.79188 4.51145 36.7016 6.3754 10.432 9.00978 -48 4 2.54774 4.08441 38.8361 -15.7139 1.18722 1.17999 -49 4 4.01487 4.13828 39.7949 0.987415 -11.5324 -1.87366 -50 4 6.38959 4.49596 38.46 -5.87199 -9.93517 1.91854 -51 4 6.36771 4.97617 36.7815 -14.8228 -10.6264 -0.132465 -52 4 5.90888 3.19548 37.1534 1.72477 39.701 11.5881 -53 4 3.39383 2.18531 37.3739 6.37275 7.50384 16.1992 -54 4 3.10231 1.69487 39.022 -2.76045 -1.11045 15.6564 -55 4 4.76015 2.00007 38.4839 16.883 -5.45935 8.37891 -56 1 1.68415 6.36719 37.3348 37.2769 -12.9922 15.6035 -57 2 0.304736 6.65563 37.6783 -19.186 -35.7743 -0.468083 -58 2 54.3638 5.41499 37.39 23.5408 9.01503 -19.9847 -59 3 54.8016 4.481 36.67 -18.0502 12.9096 17.6943 -60 4 1.81134 5.6821 36.5646 -2.38907 6.77101 2.69516 -61 4 0.26398 6.68603 38.7911 -5.02605 17.0245 3.77253 -62 2 54.6928 7.87629 36.9427 9.14228 37.5998 28.2049 -63 2 0.656467 9.08157 36.7109 -0.0956801 -8.96924 -14.639 -64 2 1.56488 9.23116 35.5658 -28.7887 -16.4207 21.28 -65 2 0.518242 10.1807 37.599 12.0453 -33.0617 -42.3022 -66 2 2.2549 10.4284 35.3456 -0.685553 9.51875 21.9154 -67 2 1.26608 11.2953 37.3573 -6.55985 56.8791 72.0683 -68 2 2.14201 11.4551 36.3269 43.9558 24.4422 -61.5967 -69 4 53.8494 8.28091 37.614 11.6877 -9.2043 -14.6276 -70 4 54.1796 7.56606 36.0251 1.84695 0.514683 -15.8045 -71 4 1.67027 8.40603 34.832 -2.56062 3.42592 3.08894 -72 4 54.8243 10.1788 38.4192 -16.1978 -2.83683 23.7337 -73 4 2.90465 10.5398 34.4584 1.04403 1.06161 3.93542 -74 4 1.2044 12.0958 38.199 3.2453 -15.1518 -32.2206 -75 4 2.76002 12.4636 36.1598 -24.4207 -43.5556 11.8549 -76 1 53.0705 5.5478 37.8043 -13.4682 25.7632 10.8407 -77 2 51.945 4.63101 37.5291 33.8243 -29.5042 -37.7332 -78 2 50.7838 5.44293 36.986 4.21111 -0.422475 -19.7833 -79 3 50.2621 6.29965 37.7355 -1.55474 -12.1519 -25.7528 -80 4 52.801 6.45436 38.3333 3.61532 -42.2821 -15.9338 -81 4 52.3053 3.83112 36.7028 -14.0928 30.7972 24.0178 -82 2 51.5456 3.79903 38.7793 9.75018 1.06621 4.26496 -83 2 50.3519 2.79661 38.4832 35.7171 10.1602 1.47909 -84 2 52.8174 3.02556 39.2171 -10.4567 -30.55 12.3487 -85 4 51.3202 4.51835 39.6193 -10.3559 -7.38818 -7.14654 -86 4 50.5612 2.13754 37.5331 -9.75373 16.6535 26.894 -87 4 49.4557 3.43665 38.3668 -10.8276 -7.01925 -6.76558 -88 4 50.2008 2.17632 39.4156 -2.83245 -1.1989 -13.0752 -89 4 53.3224 3.52205 40.064 3.32837 5.49303 2.41605 -90 4 53.5736 2.86114 38.4382 5.5955 2.25759 -8.48168 -91 4 52.5769 1.98664 39.5815 -0.855844 10.0945 -0.110617 -92 1 50.4393 5.19673 35.6351 -19.7264 9.67141 42.9571 -93 2 49.1691 5.71413 35.1171 8.57247 21.8964 -7.76629 -94 2 48.0882 4.65728 35.3507 -19.9883 30.8425 14.9148 -95 3 48.2827 3.53875 34.9335 -4.48089 -38.0316 -8.70437 -96 4 50.7426 4.33028 35.1784 2.31221 -1.81777 -1.86606 -97 4 48.9711 6.6281 35.7521 -11.2206 -0.672417 -16.6265 -98 2 49.2032 6.03091 33.5236 -0.851856 65.2811 26.1578 -99 2 47.9587 6.87959 32.9935 21.6676 -24.5773 11.3759 -100 2 48.0434 7.32811 31.5002 51.7858 -12.5586 -5.19204 -101 2 48.2074 6.22405 30.3724 28.294 -23.2516 17.4346 -102 1 48.1983 6.77555 28.9911 -71.9632 -28.6889 -6.605 -103 4 49.3393 5.11986 33.0139 -2.20502 -45.3575 -27.512 -104 4 50.0955 6.63289 33.1892 -0.645528 -4.64769 17.8413 -105 4 47.8013 7.74388 33.6913 1.36166 0.224784 -7.99748 -106 4 47.0904 6.22572 33.1496 -13.2574 -0.904539 -3.87726 -107 4 49.004 7.98659 31.3992 -27.9616 -9.11626 3.58403 -108 4 47.1978 7.96127 31.27 -20.0009 14.5444 -5.73856 -109 4 47.5417 5.33248 30.4619 -18.467 18.3391 -3.45282 -110 4 49.1897 5.66674 30.5732 -8.59668 22.4275 -14.4147 -111 4 48.9982 7.27964 28.7313 27.9214 19.6218 -9.55881 -112 4 47.3685 7.40493 28.8518 27.8731 -11.8414 7.77703 -113 4 48.0065 6.08598 28.2169 17.275 11.5652 28.2934 -114 1 46.9206 5.03778 35.9702 10.3577 18.9682 5.15831 -115 2 45.6557 4.25932 36.0398 9.08885 -0.641191 -14.1305 -116 2 44.8836 4.39003 34.674 17.924 -7.95306 73.8288 -117 3 45.3111 5.13887 33.8455 4.25406 24.8458 -47.415 -118 4 46.9247 5.98842 36.4259 -8.42518 -21.6093 -9.66 -119 4 45.9322 3.16772 36.074 -4.07513 2.77881 8.35057 -120 2 44.7235 4.66099 37.2497 -7.79148 27.6424 25.8282 -121 3 44.4559 6.1146 37.2032 37.085 -18.356 15.5747 -122 2 45.2448 4.26963 38.7181 22.7861 29.0575 -8.8559 -123 4 43.727 4.13168 37.1283 17.3832 10.5512 -0.864114 -124 4 45.2761 6.59903 37.5183 -34.0557 -21.4787 -11.7364 -125 4 45.8733 4.97275 39.4014 -10.271 -7.81482 -36.7347 -126 4 45.822 3.36133 38.5799 14.1835 -15.9263 3.29814 -127 4 44.4672 3.97387 39.4102 -27.3329 -5.40347 3.37723 -128 1 43.7561 3.68722 34.6039 -10.1769 -38.5504 10.0379 -129 2 42.7898 3.65331 33.5354 16.9998 -6.12306 -24.86 -130 2 41.7694 4.78815 33.7404 2.26966 -0.410412 -51.1213 -131 3 41.2522 5.37284 32.7445 13.6537 -18.3748 18.9894 -132 4 43.5295 2.98811 35.3697 5.99608 22.1557 -16.865 -133 4 43.3523 3.94914 32.5036 -19.5402 -19.5629 37.0771 -134 2 42.0755 2.18627 33.4863 21.9074 34.2086 -29.4327 -135 2 42.9391 0.859767 33.721 -6.85443 30.257 35.6042 -136 2 42.2358 41.4668 33.4285 -9.81834 -3.65893 -31.5778 -137 2 44.2283 0.854864 32.9471 53.2312 13.9788 40.9195 -138 4 41.6117 2.20331 32.4686 -4.39523 -13.2201 2.61812 -139 4 41.2586 2.27352 34.2121 -10.6776 -10.6054 4.67488 -140 4 43.2056 0.83773 34.8124 -0.343624 1.56324 -2.51079 -141 4 42.8118 40.5237 33.3983 6.69029 -0.569008 16.3673 -142 4 41.9597 41.5484 32.3684 -17.7546 -2.75522 -9.07631 -143 4 41.3245 41.3357 34.0216 -8.62626 -3.98831 3.9624 -144 4 44.0827 0.853311 31.8896 -3.53557 -4.02089 -36.565 -145 4 44.8236 41.822 33.2847 -5.06735 25.2561 -15.1823 -146 4 44.8583 1.80877 33.1923 -14.5958 -31.7921 -4.90526 -147 1 41.5264 5.19611 34.9737 -24.8334 44.6246 6.63495 -148 2 40.6685 6.33721 35.2699 -7.96634 19.3021 -16.1623 -149 2 41.3876 7.74941 35.097 -11.5591 -21.8484 1.81155 -150 3 40.7047 8.75309 34.8417 -6.4948 4.14558 0.128999 -151 4 41.7654 4.68652 35.8013 13.1043 -20.8107 18.8359 -152 4 39.8731 6.44712 34.4383 10.8594 -11.0445 14.3032 -153 2 39.8592 6.12601 36.6093 -15.5564 -7.24317 -37.5678 -154 3 40.7443 5.88444 37.6633 23.6025 16.5055 19.3857 -155 2 38.9047 4.85477 36.5395 -12.0583 61.1722 12.675 -156 4 39.322 7.07341 36.7706 -11.99 4.52079 9.89046 -157 4 41.1265 6.74598 37.8781 -3.93551 -10.4676 -4.79928 -158 4 38.0585 4.98564 35.7954 18.0693 -6.53498 -0.435941 -159 4 38.3566 4.77654 37.5171 8.14363 -6.92414 -3.72239 -160 4 39.543 3.99696 36.3828 0.165947 -30.6128 -6.86199 -161 1 42.7342 7.80416 35.136 -13.9315 11.8694 11.7976 -162 2 43.5142 9.02936 34.9481 17.7181 -46.9691 35.2138 -163 2 44.5073 9.42999 36.0349 -55.8537 -50.7646 50.0035 -164 3 45.375 10.2125 35.7599 43.422 25.9365 -4.74067 -165 4 43.1984 6.94617 35.4338 19.599 0.647333 4.29925 -166 4 44.1406 8.86955 34.0842 9.16679 3.97336 -28.1373 -167 4 42.9197 9.91228 34.8204 -18.5221 19.1219 -12.9063 -168 1 44.2798 8.93745 37.3587 -4.0043 10.1489 -58.0949 -169 2 45.1948 9.27519 38.4238 -4.17993 36.3676 -26.0855 -170 2 46.5575 8.73344 38.0061 12.5522 -20.4469 18.6928 -171 3 46.7331 7.49794 37.7681 -6.88831 31.8582 -6.20611 -172 4 43.377 8.45873 37.5311 9.37776 2.67644 11.4724 -173 4 45.2318 10.4158 38.3238 5.33405 -13.6354 14.6161 -174 2 44.7823 8.84756 39.8415 35.39 -32.4267 -9.44324 -175 2 45.5211 9.64049 40.9405 -33.0234 -16.4934 27.578 -176 2 45.0293 11.1067 41.0295 26.955 13.1382 1.75579 -177 2 45.9939 11.883 0.056845 5.44769 -3.52142 -7.77113 -178 1 45.567 13.2463 0.389189 -21.8942 22.5552 58.7427 -179 4 44.9649 7.71121 39.9163 -1.68078 22.7299 4.94117 -180 4 43.7292 8.96914 40.0006 -34.3585 3.91778 0.788359 -181 4 46.6326 9.56148 40.8729 -4.12637 -0.755434 -1.7729 -182 4 45.1589 9.15652 0.052119 21.5355 9.01144 -26.2886 -183 4 44.0384 11.1525 41.4882 -17.6691 -1.8484 1.78047 -184 4 44.9645 11.6456 40.0488 1.32443 -5.52779 3.51863 -185 4 46.9936 12.0079 41.4163 -11.0521 -7.71607 17.8496 -186 4 46.0863 11.2417 1.01939 6.64185 25.7549 -16.0759 -187 4 45.6176 13.9315 41.5535 6.39074 -1.54943 -2.93714 -188 4 46.1207 13.6426 1.21669 -15.3499 -18.2055 -38.2327 -189 4 44.572 13.3465 0.725918 28.6554 -12.4083 -12.8179 -190 1 47.5723 9.62675 38.0225 1.62241 16.525 -13.2778 -191 2 48.9413 9.31976 37.6447 28.3505 6.17866 3.85392 -192 2 49.7947 9.65595 38.897 -51.2415 76.6103 -24.0977 -193 3 49.6063 10.7902 39.4401 12.9093 -42.4425 -12.577 -194 4 47.4538 10.6389 38.3066 -1.81401 -22.4625 -4.08398 -195 4 49.0905 8.23756 37.4201 -8.03606 -0.867672 -0.903629 -196 2 49.3577 10.1392 36.3514 -15.5639 -8.86216 -34.5575 -197 3 48.3381 9.84531 35.2995 20.2521 4.60838 26.9691 -198 2 50.6821 9.73379 35.6575 -13.1705 -1.52152 26.2758 -199 4 49.443 11.2403 36.5183 -14.2645 -0.263993 8.70321 -200 4 47.5106 10.2398 35.5579 0.218555 2.62212 3.26783 -201 4 50.9323 10.3465 34.7687 -2.88514 -3.55444 -7.60949 -202 4 50.7732 8.65192 35.4951 -3.14548 -9.24106 -12.1943 -203 4 51.4763 9.94768 36.3674 17.1427 5.0591 10.0517 -204 1 50.5022 8.69828 39.4305 24.0939 -43.466 77.1583 -205 2 51.0483 8.71922 40.8082 -0.802123 10.2433 -32.8315 -206 2 52.5183 8.33859 40.7231 46.1376 25.1574 58.8821 -207 3 52.8914 7.33748 40.1143 13.0446 10.4001 -14.6089 -208 4 50.6189 7.73433 39.1341 -5.48208 -8.91176 -29.3848 -209 4 51.0045 9.75097 41.1725 -0.547397 17.2241 4.09797 -210 2 50.2922 7.85282 41.8455 19.6626 -50.7873 -7.63422 -211 2 50.2811 6.29504 41.471 -17.2864 -17.6708 26.7503 -212 2 48.8668 8.31684 0.212195 -17.3783 63.506 12.4232 -213 2 49.3691 5.38294 0.512646 14.3884 65.6628 -4.02696 -214 4 50.9326 7.9114 0.860642 -12.3241 5.1929 3.57402 -215 4 51.3127 5.83882 41.5287 -4.74499 10.5855 -5.5164 -216 4 49.8921 6.13652 40.4532 1.6457 0.843055 -11.9856 -217 4 48.0317 8.06123 41.424 13.0217 -7.20036 -2.54126 -218 4 48.8693 9.49201 0.254246 -0.917701 -32.4673 -2.46528 -219 4 48.5263 8.05212 1.23597 1.41612 -6.96817 -0.649274 -220 4 48.2816 5.57755 0.309314 6.34191 -1.32326 5.14384 -221 4 49.6363 5.72968 1.56057 -11.1106 -15.1353 -5.99489 -222 4 49.54 4.32324 0.397743 7.27301 -24.1582 -2.3836 -223 1 53.3925 9.14738 41.5454 -19.7766 -15.6836 -47.6014 -224 2 54.8543 9.29866 41.641 -12.5045 -20.0873 29.727 -225 2 0.407838 8.25913 0.762984 -29.7207 32.5524 -37.8245 -226 3 54.8643 8.2564 1.86493 17.0269 -29.0845 20.332 -227 4 52.9285 9.69819 0.341812 -9.11605 14.2566 13.2302 -228 4 0.291486 9.0623 40.6877 9.99865 -5.39191 -34.8298 -229 2 0.359683 10.7121 0.203065 -6.90664 -3.88067 -14.6485 -230 3 54.4765 11.8025 41.752 -11.2022 -21.2627 -5.88002 -231 2 1.6614 11.1001 41.4135 2.5167 -27.9916 -13.3179 -232 4 0.487415 10.6137 1.28953 0.410521 18.1219 13.0764 -233 4 54.0953 12.1937 0.613553 1.59003 1.59721 11.7532 -234 4 1.92456 12.0955 41.7398 14.8193 23.7252 4.53742 -235 4 1.52762 11.126 40.2979 3.61624 1.93597 7.36374 -236 4 2.5241 10.4069 41.6364 -8.38015 7.04993 1.52106 -237 1 1.45864 7.53391 0.367476 0.545631 9.71791 -21.8799 -238 2 2.25081 6.65311 1.15507 26.446 -0.0641839 -18.4938 -239 2 3.7671 6.96757 0.917085 -57.4365 -22.4689 85.9929 -240 3 4.15047 7.41488 41.7757 21.4144 12.1214 -29.7802 -241 4 1.8001 7.62601 41.3064 3.76941 -0.348546 3.21752 -242 4 1.98413 6.84865 2.19976 1.77378 -4.57114 13.3572 -243 2 1.98593 5.20856 0.673411 -39.0557 8.05152 -2.47083 -244 2 0.499001 4.77546 0.950638 51.92 -35.3278 3.54994 -245 2 0.302449 3.38226 0.307039 12.2804 5.92691 27.6936 -246 2 0.318833 4.59091 2.46762 -57.1886 17.9845 23.4913 -247 4 2.62035 4.47984 1.15306 24.0478 -12.5257 10.4353 -248 4 2.17019 5.14075 41.4887 6.74012 -0.473312 -2.7006 -249 4 54.8482 5.46061 0.448133 -33.0903 28.7369 -7.07308 -250 4 54.2241 3.15851 0.337643 -14.6094 -12.7265 -2.24176 -251 4 0.881511 2.58656 0.876485 -8.96903 11.0382 -11.5819 -252 4 0.635114 3.38296 41.1822 2.70741 -4.49002 -20.1461 -253 4 0.991181 3.80938 2.86091 2.53728 -4.51346 7.06316 -254 4 54.1796 4.30541 2.72425 38.6722 3.44969 -10.622 -255 4 0.495432 5.52724 3.08531 2.73328 -11.7655 -13.2166 -256 1 4.49387 6.66874 2.05101 59.25 35.5651 -63.8633 -257 2 5.97745 6.82619 2.08157 -13.5783 -40.6566 -15.6714 -258 2 6.57448 5.47381 2.54294 67.6927 12.9151 50.3283 -259 3 7.53922 5.43765 3.33186 -5.78511 6.85237 -12.8739 -260 4 4.10191 6.33546 2.9164 -11.2688 -10.0369 11.6191 -261 4 6.35409 6.85375 1.02753 1.73229 12.3732 3.55997 -262 2 6.47001 8.00523 2.96248 -35.1701 -2.47648 -9.01657 -263 2 6.52316 9.38515 2.26526 -52.089 -36.3571 -52.5381 -264 2 6.66039 10.5311 3.17647 23.2175 30.5211 32.7092 -265 3 7.81872 10.9467 3.49478 5.10838 -9.19539 -6.96115 -266 3 5.64173 11.0573 3.6767 -20.5888 -1.64097 0.158765 -267 4 7.42654 7.87231 3.41702 35.4584 -16.2138 5.63399 -268 4 5.81838 7.86205 3.84167 -4.54492 27.3919 10.2645 -269 4 5.56237 9.49095 1.59664 20.5708 1.89307 25.306 -270 4 7.29681 9.38215 1.47849 13.2355 1.21078 1.19218 -271 1 6.08096 4.31767 2.17259 -39.414 -15.8224 -24.7678 -272 2 6.39518 2.91476 2.36043 4.12081 37.0723 19.1814 -273 2 7.75633 2.62628 1.79624 63.8838 -9.4865 -25.3011 -274 3 8.33634 3.36937 0.946953 -27.4154 -16.213 26.3787 -275 4 5.28658 4.43126 1.58002 -24.0887 -1.16266 -20.2566 -276 4 6.54455 2.77577 3.45017 -8.86613 -5.70482 8.60941 -277 2 5.25427 2.02933 1.82805 -30.6144 -48.6247 5.61864 -278 2 3.85552 2.1153 2.66383 78.486 27.413 32.1434 -279 2 4.87851 2.27508 0.297641 -10.4566 -15.7718 22.2154 -280 4 5.65998 0.937168 1.99721 -15.6319 23.5495 -14.0675 -281 4 3.98898 1.63213 3.72107 -1.04911 23.3354 -24.3429 -282 4 3.15409 1.48884 2.20213 -45.477 -24.0418 -26.2275 -283 4 3.51802 3.20813 2.70746 -2.40249 -20.6527 6.6832 -284 4 4.39172 3.24426 0.119355 -1.44384 9.21297 0.0772101 -285 4 4.19746 1.51559 41.6955 12.4172 8.09212 16.5491 -286 4 5.82002 2.28129 41.6778 17.5327 1.3005 -22.4945 -287 1 8.43941 1.53208 2.30673 1.7292 42.4201 -39.4356 -288 2 9.76672 1.10452 1.81012 11.995 -19.5667 23.3003 -289 2 9.60964 41.7637 0.921245 4.05677 21.7498 -11.1929 -290 3 8.59567 41.087 1.06007 7.18507 -15.5872 -8.58634 -291 4 7.90606 0.81761 2.76924 -8.42032 -19.931 16.3865 -292 4 10.4026 1.87877 1.34085 -18.5158 15.1062 -12.7744 -293 2 10.6232 0.647963 3.0246 -34.7832 -39.5023 14.4787 -294 2 11.0993 1.6812 4.04079 16.2934 16.5377 23.708 -295 2 12.4719 2.27616 3.59128 -46.8378 -2.52013 6.7155 -296 3 13.4675 1.63575 4.02276 22.0629 14.477 -13.463 -297 3 12.4471 3.24187 2.73298 15.8946 -22.2661 28.0778 -298 4 11.4641 0.045385 2.63277 10.8271 5.92943 5.75519 -299 4 10.0353 41.7446 3.607 8.35649 20.5438 -12.0897 -300 4 11.2832 1.11765 5.0427 -4.51453 13.9694 -21.6118 -301 4 10.341 2.4932 4.3105 9.65416 -13.2167 -8.7997 -302 1 10.6494 41.4676 0.039711 8.78515 0.440053 18.9323 -303 2 10.7217 40.2184 41.1909 10.2574 -28.5822 12.1248 -304 2 10.6889 38.8907 0.171469 -17.3791 70.2346 -13.2363 -305 3 10.1368 37.8928 41.652 0.864281 -20.5458 12.6113 -306 4 9.82473 40.2067 40.5786 -14.2689 -8.84554 -18.4029 -307 2 12.0478 40.1799 40.3262 -31.3786 20.6535 10.6233 -308 2 12.4388 41.6551 40.4794 16.223 20.8678 -10.392 -309 2 11.8805 0.34241 41.7792 -28.1233 -36.7072 -34.4959 -310 4 11.9102 39.8982 39.2292 -1.08614 0.893428 17.4874 -311 4 12.7409 39.4563 40.8087 9.93344 3.46544 -3.32375 -312 4 12.0845 0.391154 39.5895 8.62314 -16.2997 14.2071 -313 4 13.5502 41.7447 40.5643 -1.70925 0.910467 -12.4735 -314 4 11.7305 1.40344 41.6414 -9.5626 24.5309 -2.35213 -315 4 12.5687 0.26268 0.684216 19.8182 -9.73862 27.9097 -316 1 11.1854 39.0885 1.40191 34.1901 -11.3327 18.3686 -317 2 11.4785 38.09 2.41707 -37.5808 13.2867 4.32174 -318 2 10.2405 37.7763 3.3402 -0.155099 -13.1844 6.87934 -319 3 10.4378 36.9653 4.27207 -11.6928 9.67513 -22.7546 -320 4 11.6756 39.9703 1.62918 -8.97807 -2.58442 -2.36164 -321 4 11.7153 37.147 1.89269 -3.37493 -11.1801 -2.58831 -322 2 12.7263 38.4682 3.25859 -32.7454 -15.529 27.3397 -323 3 12.5885 39.7408 3.87129 1.54426 18.5893 -11.5354 -324 4 13.5945 38.4441 2.61946 23.9879 5.88222 -14.7576 -325 4 12.9197 37.685 4.04183 -3.566 10.9198 -2.82194 -326 4 11.9285 39.8531 4.57214 8.5625 -16.1459 -5.7164 -327 1 8.98961 38.3717 3.14779 19.3135 28.1448 -76.0315 -328 2 7.78009 38.1002 3.90315 -4.26896 22.0341 0.229441 -329 2 6.83069 37.1869 3.18241 -25.8564 -25.3069 -16.1867 -330 3 6.84398 36.9785 1.97125 20.9058 23.903 -13.4458 -331 4 8.79049 38.9506 2.20714 10.5577 -30.8167 54.9659 -332 4 8.11274 37.5073 4.75427 1.14536 -6.32615 23.8911 -333 2 7.0077 39.4163 4.32571 4.21253 -4.87986 18.678 -334 2 7.75781 40.1168 5.42156 46.58 -14.1846 12.934 -335 3 8.30143 41.2262 5.21331 -14.6188 11.6514 -5.86083 -336 3 8.10545 39.4797 6.46784 -18.045 3.20128 -4.6129 -337 4 6.01572 39.173 4.78754 -1.72287 0.045533 -10.2864 -338 4 6.87032 40.2048 3.55457 -4.98407 -10.6589 -12.5629 -339 1 5.91154 36.4899 3.88964 18.6928 -0.691686 25.3425 -340 2 4.98537 35.571 3.20749 -24.0931 31.8814 30.8723 -341 2 3.79198 36.4499 2.67545 58.5623 50.3783 54.6165 -342 3 3.60244 37.6478 3.05835 4.98938 -42.2114 -12.2812 -343 4 5.945 36.5545 4.93654 -10.5756 -4.83423 -16.3239 -344 4 5.5221 35.038 2.40161 -3.05594 2.46612 -11.4716 -345 2 4.40384 34.4728 4.15145 -1.70261 45.9252 5.92389 -346 3 3.98498 35.0725 5.41787 -8.00202 -46.5665 -16.5053 -347 2 5.48475 33.4747 4.46048 0.249803 -29.9924 71.6177 -348 4 3.54337 34.0389 3.61058 -6.82183 -12.9435 7.69028 -349 4 3.62675 34.2747 5.86698 6.39679 27.749 2.05336 -350 4 5.85279 32.9868 3.57629 11.3184 -16.9973 -22.3871 -351 4 5.09248 32.6743 5.23041 8.97186 17.4623 -32.7541 -352 4 6.34746 33.9006 5.03324 -0.476546 4.78606 -11.5797 -353 1 3.00152 35.8184 1.87366 -46.1462 -42.5584 -55.0681 -354 2 1.77021 36.3468 1.35692 -36.7765 14.163 11.1031 -355 2 0.721356 36.5788 2.57059 18.2386 -29.7925 23.2574 -356 3 54.9678 37.5551 2.63992 10.9193 3.0322 -8.68025 -357 4 3.31287 34.9586 1.40066 1.19836 -3.77239 4.28893 -358 4 2.05059 37.3327 0.922928 -11.4048 10.7741 9.22697 -359 2 1.07197 35.5705 0.158527 41.3495 -39.9506 -9.05678 -360 2 1.73776 35.9497 40.6674 -26.4234 39.8053 33.0301 -361 2 54.5322 35.7209 0.133627 -14.8072 -12.0564 -1.20894 -362 2 3.23928 35.9487 40.63 7.11928 -24.1756 -12.68 -363 4 1.32474 34.4514 0.269568 -7.211 20.0201 5.35532 -364 4 1.47926 37.0502 40.6385 -3.87579 -7.90549 -26.2729 -365 4 1.36122 35.3789 39.7771 -4.72819 3.84386 12.155 -366 4 54.087 35.0558 41.2526 3.68912 7.63158 3.17282 -367 4 54.2076 36.7772 41.8385 0.949253 -6.55132 4.09096 -368 4 54.0676 35.3362 1.10912 4.22691 12.456 -17.368 -369 4 3.57003 34.9443 40.8434 9.13412 -24.8126 8.40569 -370 4 3.78301 36.5792 41.3142 5.34684 18.5101 18.1918 -371 4 3.6567 36.127 39.6372 -0.20476 7.44967 -14.9904 -372 1 0.712989 35.6055 3.58431 38.0557 9.26554 -59.6495 -373 2 0.05279 35.6483 4.83915 -15.0961 2.42646 38.658 -374 2 0.191347 37.0144 5.48801 7.00468 33.8104 1.40802 -375 3 54.154 37.7008 5.76148 35.4113 -11.6645 -8.2681 -376 4 1.23482 34.733 3.35856 -11.2418 4.01634 10.8504 -377 4 53.9671 35.581 4.69172 -20.2496 -5.13772 -12.456 -378 2 0.463881 34.4895 5.81355 17.031 15.9659 -33.5139 -379 2 54.8083 34.3393 7.16558 -30.7527 -16.2072 -11.1445 -380 2 0.00712 35.4957 8.10271 3.59003 -8.69902 15.3198 -381 3 54.0967 36.3529 8.34542 -1.77732 -9.94333 -12.6544 -382 3 1.07192 35.4587 8.7399 35.3598 16.353 18.5034 -383 4 1.56574 34.5304 5.94519 0.590681 0.639559 4.32925 -384 4 0.280894 33.5741 5.23349 -1.52963 -16.3279 0.16603 -385 4 0.223173 33.3947 7.64873 -6.8885 8.42796 -3.46601 -386 4 53.7112 34.1554 6.97481 9.65493 -2.46487 7.60139 -387 1 1.50649 37.4152 5.65526 -22.458 -31.2308 -17.0045 -388 2 2.02438 38.6379 6.15097 -3.22056 29.1656 36.4104 -389 2 1.58588 39.8651 5.40701 -13.5031 20.9194 -76.104 -390 3 1.07209 40.8553 5.93778 8.03965 -15.1327 11.1864 -391 4 2.24702 36.741 5.38136 -6.00826 1.88497 2.51587 -392 4 1.72629 38.833 7.20228 -22.1923 -11.9073 0.0585309 -393 2 3.51949 38.6121 6.24971 43.6984 -50.5664 -0.0787057 -394 2 4.11017 39.7004 7.10642 -5.48661 12.2779 -12.8977 -395 3 4.55887 40.7033 6.57435 6.12607 11.2234 -5.55098 -396 1 3.97545 39.5562 8.42942 -13.6958 7.00999 41.6346 -397 4 3.92653 38.5973 5.19958 6.67843 9.43594 11.2804 -398 4 3.90699 37.6191 6.72902 -10.8805 23.4385 -12.7616 -399 4 3.35162 38.8096 8.83526 13.2612 9.60447 -6.60232 -400 4 4.25023 40.3377 9.09595 -2.56729 -20.1743 -21.9158 -401 1 1.64621 39.8034 3.99517 -50.1719 52.4074 67.8966 -402 2 0.960547 40.8538 3.14427 -3.37695 -31.9032 -17.009 -403 2 54.4047 41.0035 3.47138 71.1401 19.2662 2.3079 -404 3 53.9887 0.221409 3.63964 -22.8765 18.4333 9.81455 -405 4 2.07659 38.9926 3.63308 18.9969 -31.9912 -34.7926 -406 4 1.39808 41.8727 3.34889 0.835518 -9.01277 1.27119 -407 2 1.14841 40.4887 1.56595 -9.49555 20.2148 39.7014 -408 2 0.469253 41.6189 0.677094 10.8075 11.2475 47.495 -409 2 2.6528 40.4777 1.25625 -15.459 -47.3647 -39.6369 -410 4 0.776571 39.4398 1.40308 -11.1955 11.1351 -6.38222 -411 4 54.3852 41.8501 0.825468 -5.0709 -17.7069 -2.05205 -412 4 0.696071 41.5065 41.5456 0.0730393 -4.82529 -32.9133 -413 4 0.904174 0.691668 0.985463 6.30616 -9.41897 -5.2369 -414 4 2.64269 40.3122 0.13166 16.7998 18.1471 15.5753 -415 4 3.13789 39.5289 1.58622 -1.56816 4.1145 9.56394 -416 4 3.29805 41.2779 1.59825 6.1243 20.9887 1.16769 -417 1 53.684 39.9214 3.65257 -36.1976 13.6917 8.19643 -418 2 52.3006 39.9493 4.06589 -56.8626 -17.5359 -10.0305 -419 2 52.042 40.5256 5.46425 9.62461 10.2848 -5.14962 -420 3 51.0331 41.2228 5.70144 14.4944 -11.372 -4.23176 -421 4 54.0189 39.0607 3.30247 15.8062 -40.5534 -6.95561 -422 4 51.6931 40.6476 3.38276 19.0563 -8.07776 7.22418 -423 2 51.5622 38.4976 3.96193 14.5706 2.1127 21.5154 -424 2 51.4158 37.9814 2.50572 24.752 -20.928 -15.9835 -425 2 51.0077 36.4305 2.37064 11.3099 30.9145 9.08043 -426 2 50.8522 35.9939 0.907307 -46.4939 -7.09254 -49.7464 -427 1 50.1475 34.7025 0.671588 69.6077 -32.405 2.84717 -428 4 50.6006 38.4842 4.55016 3.73478 6.81079 -18.2086 -429 4 52.1831 37.7463 4.55262 -3.81101 12.3643 -13.1539 -430 4 52.4118 38.1657 2.02278 1.77015 -18.5404 7.48984 -431 4 50.8584 38.5927 1.79489 -26.3581 9.74254 8.34414 -432 4 50.0453 36.2246 2.88499 -2.56193 3.57961 3.68626 -433 4 51.7703 35.8375 2.92238 0.215708 -6.73604 -5.33103 -434 4 51.7691 36.0437 0.240386 -6.2594 -4.10885 19.6388 -435 4 50.1039 36.686 0.3716 22.9763 1.60597 16.3794 -436 4 50.5914 33.8993 1.10828 2.95648 12.8391 18.7814 -437 4 50.3001 34.3737 41.6268 -19.3387 19.3411 -4.27099 -438 4 49.2006 34.6111 0.961468 -24.084 7.88088 -0.582308 -439 1 53.0235 40.2561 6.35237 -32.3128 10.4579 -5.0201 -440 2 53.1129 40.7256 7.70074 -41.6363 -1.15369 57.3167 -441 2 53.1798 0.352689 7.77253 -34.9991 -20.8035 37.2736 -442 3 52.5119 1.01286 8.63006 21.7579 -17.6925 -30.8538 -443 4 53.6931 39.5673 6.06584 22.7894 -18.2937 1.39271 -444 4 52.0865 40.4844 8.3065 35.7608 3.68212 -29.1988 -445 2 54.2701 40.0034 8.46069 6.08948 28.5921 -6.02695 -446 4 54.5971 40.5153 9.39975 -22.234 -14.34 10.1754 -447 4 0.201561 40.2092 7.93116 13.6903 -2.08726 -21.3806 -448 4 54.1655 38.8939 8.41526 -0.559105 0.118215 15.5404 -449 1 53.9752 0.884949 6.87383 32.3465 35.364 -24.1241 -450 2 54.062 2.35993 6.75215 -1.13821 -0.709889 -34.8218 -451 2 52.7471 3.02097 6.14186 4.92946 35.4069 59.7439 -452 3 52.3227 4.16587 6.4978 18.9545 -33.4145 3.00952 -453 4 54.7345 0.266534 6.4753 -18.8262 24.4346 -1.05702 -454 4 54.2802 2.76759 7.79054 -12.1814 3.84369 -14.3249 -455 2 0.185451 2.81859 5.73187 27.2059 46.9588 30.4236 -456 2 1.71808 2.36893 6.1571 -63.9259 -20.0653 -29.4315 -457 2 1.9764 2.63004 7.63437 43.6306 13.7343 2.97159 -458 2 3.27263 1.81187 8.04275 -33.9139 -3.58936 -6.58926 -459 1 3.78328 2.11956 9.34176 26.6398 21.4152 24.507 -460 4 0.173809 4.01773 5.82442 4.54198 -39.0295 -6.50933 -461 4 54.8792 2.64498 4.65574 11.0791 -10.5686 10.592 -462 4 2.43618 2.90609 5.45978 -2.35628 -10.1976 10.4282 -463 4 1.76796 1.2289 6.01344 4.57023 21.5888 -8.89179 -464 4 1.21473 2.41369 8.37281 -19.449 -19.8593 5.28327 -465 4 2.02309 3.72579 7.75906 18.9296 5.96095 -1.30777 -466 4 4.11389 1.88412 7.33652 2.51142 0.584915 -8.00636 -467 4 2.91513 0.727469 8.06593 14.1612 11.4678 0.952909 -468 4 3.87966 1.33238 9.93849 2.65093 -23.7146 9.43734 -469 4 3.29203 2.7681 9.89323 -42.3935 13.6729 9.41431 -470 4 4.65765 2.6209 9.4154 12.4458 -11.5538 -21.8273 -471 1 52.0387 2.32512 5.28273 -51.3661 -11.8477 -11.6622 -472 2 50.6641 2.72274 4.84157 25.7857 6.93126 13.1254 -473 2 49.5414 2.57609 5.91007 27.6149 -7.37739 5.45836 -474 3 48.7805 3.52104 6.09585 -8.9672 -1.93713 4.87304 -475 4 52.4681 1.55108 4.79165 6.19099 -18.5603 -5.58783 -476 4 50.6769 3.82983 4.70864 1.41274 -1.50214 -10.3294 -477 2 50.3587 2.05695 3.49156 -22.4167 -18.5545 -8.10533 -478 2 51.392 2.35646 2.3419 -24.5199 12.8001 2.40788 -479 2 48.9327 2.41504 2.97856 -9.14079 -2.86031 26.3031 -480 2 51.1945 1.4129 1.15651 29.522 -13.6455 -15.5517 -481 4 50.3189 0.937191 3.7523 9.08136 15.4094 -11.3523 -482 4 52.3823 2.12188 2.68097 31.5971 -0.36407 15.4796 -483 4 51.4014 3.46798 2.06765 -1.078 -19.9026 -0.0406259 -484 4 48.2117 2.12758 3.78451 -1.04241 22.2186 2.00084 -485 4 48.5813 1.67256 2.28636 2.21501 -12.0529 -35.8697 -486 4 48.7327 3.44552 2.54328 5.48386 -12.5705 11.3103 -487 4 52.1623 1.3706 0.452926 -36.5132 5.61179 20.4585 -488 4 50.2881 1.70969 0.600596 -1.11419 -0.409473 -10.6314 -489 4 51.0211 0.353877 1.53511 3.53067 13.7442 -8.50616 -490 1 49.5623 1.51743 6.77214 29.0905 -0.0770965 -25.5222 -491 2 48.7084 1.41716 7.91723 -3.12505 -21.6463 4.96918 -492 2 48.8549 2.61932 8.82546 31.903 20.2748 29.0475 -493 3 47.906 3.05048 9.46897 -16.8524 2.35798 -10.3438 -494 4 50.2118 0.710522 6.59294 -12.9921 18.0739 4.61122 -495 4 47.6425 1.393 7.52359 9.91609 0.328738 10.372 -496 2 49.0787 0.089334 8.73016 -60.0302 -9.6098 -44.8862 -497 2 48.2852 41.7441 10.0242 3.18066 15.7764 -9.96769 -498 2 46.7826 0.060746 9.96682 -2.34726 -14.6607 41.7592 -499 3 46.2233 0.511631 10.9878 -5.96974 4.10403 -23.4495 -500 1 46.1388 41.3329 8.97776 32.9533 20.065 15.0282 -501 4 50.1182 0.035639 8.93296 42.8084 2.68407 12.3764 -502 4 48.8904 41.1121 8.0025 3.88899 17.9501 19.4277 -503 4 48.6104 0.602172 10.7954 4.73737 -18.8132 -0.914642 -504 4 48.4759 40.6816 10.3394 0.165969 9.19265 10.3013 -505 4 46.673 40.8953 8.25882 14.2049 -15.3063 -26.5369 -506 4 45.1569 41.364 8.91958 -49.0994 -2.53611 0.320683 -507 1 50.1114 3.13932 9.06291 -28.12 32.8195 0.337886 -508 2 50.3404 4.32895 9.98795 -1.65029 -57.226 -17.8628 -509 2 50.0322 5.66893 9.41362 -36.2334 -9.83443 -38.9072 -510 3 49.3598 6.44562 10.1062 15.3309 6.40082 -5.38514 -511 4 50.9085 2.84633 8.5071 12.3092 -10.0263 -3.45928 -512 4 49.5835 4.28149 10.7848 -3.38143 -13.253 14.1405 -513 2 51.7461 4.22789 10.5468 25.7206 14.4209 20.1557 -514 2 51.9023 5.17188 11.7283 -67.9962 -1.36338 64.1829 -515 3 50.9364 5.19004 12.6002 28.9599 1.18541 -41.9912 -516 3 52.9319 5.83594 11.9785 18.8411 2.87417 -24.5577 -517 4 52.4276 4.5214 9.72474 12.6887 -3.13287 0.413374 -518 4 52.058 3.21563 10.9647 -9.24198 7.66389 -16.6414 -519 1 50.112 5.78532 8.03139 7.52033 29.602 25.459 -520 2 49.6799 7.08933 7.40639 14.3534 -30.8181 22.5674 -521 2 48.2409 7.17209 6.9711 -2.24553 44.7474 7.57528 -522 3 47.5844 8.22961 7.08968 18.1939 -9.81929 5.41459 -523 4 50.7064 5.09112 7.53173 -12.638 14.3936 -6.22521 -524 4 49.7159 7.84119 8.19837 -7.36252 7.51614 21.2329 -525 2 50.7023 7.64954 6.44039 -16.0213 -40.4967 -48.4302 -526 2 50.7257 6.82423 5.08423 -13.7427 47.9405 2.4816 -527 2 51.6418 7.28287 3.94021 29.8472 39.248 73.299 -528 2 53.127 6.98483 4.24688 1.29977 19.7271 -18.9866 -529 1 53.757 7.95176 5.17575 -11.1866 13.844 -62.5277 -530 4 51.636 7.68275 6.97838 28.3767 1.23741 1.58475 -531 4 50.4129 8.66535 6.18803 -0.179632 23.7408 -3.11047 -532 4 49.7187 7.01043 4.64523 -5.97611 -10.1095 1.48316 -533 4 50.8061 5.7562 5.2149 3.4405 -22.8364 10.0865 -534 4 51.5118 8.41472 3.72654 -1.36136 -26.6124 -3.74792 -535 4 51.4228 6.66542 3.12568 -20.7249 -22.8033 -58.4365 -536 4 53.6095 7.03345 3.2004 3.85152 5.93338 28.8514 -537 4 53.3314 5.96083 4.57939 -0.112253 -9.13532 8.29834 -538 4 53.309 8.86524 5.1699 0.162268 -2.42959 1.84412 -539 4 54.6672 8.17057 4.81193 19.2107 -0.812718 7.6593 -540 4 53.869 7.69009 6.11536 0.991087 -15.435 33.6166 -541 1 47.7293 6.1299 6.36528 -13.6545 -50.1986 -45.913 -542 2 46.4151 6.11998 5.73127 12.5517 -4.35851 26.1033 -543 2 45.4457 5.24236 6.50095 -54.5114 -4.35957 -22.3583 -544 3 44.2134 5.34166 6.22856 33.5613 3.36987 15.344 -545 4 48.2957 5.29705 6.08439 -4.65701 16.0313 11.2062 -546 4 46.0246 7.14829 5.83676 -12.413 4.85954 -1.2939 -547 2 46.3966 5.7006 4.23247 16.9743 -35.0719 19.3242 -548 2 46.8471 6.79722 3.31369 7.95245 13.9142 -51.9109 -549 2 46.0679 8.12855 3.29075 19.7668 12.2354 20.4517 -550 3 44.9703 8.28242 2.6836 -5.20426 -7.76074 -7.99938 -551 3 46.5716 9.08042 3.9624 -5.49585 -3.27174 -8.75295 -552 4 45.3525 5.37075 3.98324 7.30106 1.55378 -6.68576 -553 4 47.1483 4.79199 4.10624 -28.8106 21.423 0.303262 -554 4 47.0017 6.41037 2.24023 -12.0684 6.13088 18.9752 -555 4 47.8815 7.05675 3.60692 6.175 4.12296 2.89493 -556 1 45.8802 4.28795 7.34048 -32.7588 9.8199 -6.22093 -557 2 44.9801 3.41661 8.05582 7.11941 -0.762777 6.83491 -558 2 44.2841 2.32798 7.24802 57.2007 25.2815 -35.4523 -559 3 43.4338 1.62321 7.71908 -38.784 -24.7635 26.1598 -560 4 46.8556 4.13399 7.46211 34.7056 -9.13536 7.69054 -561 4 45.5867 2.90913 8.82837 -2.10841 -5.06197 5.41207 -562 4 44.2233 4.00883 8.63057 1.71074 -0.990438 -6.10924 -563 1 44.7516 2.08483 5.98824 -37.8462 -38.4135 -8.16449 -564 2 44.1597 1.01431 5.13579 -9.65639 -34.378 14.28 -565 2 44.8664 41.5016 5.49089 -11.1964 37.9598 3.64882 -566 3 46.103 41.4369 5.57345 -11.1149 2.47206 2.88353 -567 4 45.5262 2.474 5.47152 21.0389 22.2918 12.8005 -568 4 43.0172 0.862184 5.40503 31.5022 14.6416 -15.142 -569 2 44.4162 1.4085 3.60515 5.8653 -21.2021 14.2009 -570 2 43.5161 2.65984 3.27425 41.0117 -18.0627 24.5931 -571 2 44.2213 0.116838 2.67583 -30.001 3.65408 12.6342 -572 2 43.604 3.10049 1.82796 -41.0466 14.5447 22.3036 -573 4 45.4923 1.71966 3.57573 -0.138156 -3.02814 -11.6903 -574 4 43.8008 3.50537 3.97163 -2.46499 -4.10631 -11.566 -575 4 42.524 2.38704 3.60859 -29.3388 -0.685173 -5.23931 -576 4 44.5714 0.285197 1.65031 -2.2735 9.46305 -11.1841 -577 4 43.1006 41.7553 2.65834 21.2852 6.7215 -5.00379 -578 4 44.7366 41.0658 2.93547 0.768749 11.7185 9.28335 -579 4 44.5004 3.68719 1.60884 14.6444 -0.878149 -7.94907 -580 4 42.7371 3.8089 1.73084 7.8177 -0.664582 -10.9353 -581 4 43.3892 2.25631 1.16493 5.07933 -5.28874 -15.8541 -582 1 44.0858 40.4147 5.76991 -7.82686 10.7063 0.0613705 -583 2 44.6952 39.2248 6.26612 46.8291 -49.1328 2.55503 -584 2 45.6273 38.4983 5.15014 -10.8203 -24.5871 -10.3389 -585 3 45.1671 38.1033 4.04814 1.93862 22.6196 32.2907 -586 4 45.3114 39.4262 7.20071 -5.62912 7.00222 -16.0196 -587 2 43.5561 38.2867 6.74046 -22.632 -0.869913 -14.9675 -588 2 42.367 38.8131 5.80069 8.99216 14.1028 58.1483 -589 2 42.6345 40.3137 5.92605 0.476166 33.3948 28.8915 -590 4 43.357 38.4284 7.8368 -6.62566 13.9326 -12.0425 -591 4 43.8048 37.1922 6.7609 -3.60965 9.48681 -21.6917 -592 4 41.3136 38.6254 6.13023 8.266 -9.51845 1.65532 -593 4 42.4187 38.6156 4.74928 6.70678 -23.3061 -29.6074 -594 4 42.2773 40.816 6.98347 15.1971 -23.3227 -46.4987 -595 4 42.1119 40.8277 5.08767 -3.55372 4.4917 2.49103 -596 1 46.8487 37.9967 5.55394 17.2019 12.2692 25.006 -597 2 47.7247 37.0178 4.87762 -6.21972 -16.2302 -28.9734 -598 2 47.0354 35.8358 4.10675 -5.54108 30.4574 49.2069 -599 3 47.4638 35.4602 3.01706 -3.2731 6.26074 0.626287 -600 4 48.411 37.4477 4.12082 -11.0175 18.1135 -5.68521 -601 2 48.6499 36.5231 5.98749 -16.6595 -15.0747 15.7963 -602 2 48.891 37.7945 6.79307 0.637735 -25.9659 35.4869 -603 2 47.512 38.4108 6.81936 -6.06228 0.364124 -35.7901 -604 4 49.55 36.0027 5.64818 14.2665 0.926908 -8.4052 -605 4 48.1323 35.7432 6.6035 -1.04051 5.39171 0.916503 -606 4 49.6303 38.4539 6.33816 11.9938 9.28906 -4.17289 -607 4 49.2156 37.5316 7.87598 -0.828426 8.45001 -24.626 -608 4 47.6223 39.5002 6.92189 -5.61966 10.135 -2.25063 -609 4 46.9349 38.0418 7.65693 -11.0214 -6.34351 22.8142 -610 1 45.9811 35.3016 4.79343 19.1712 31.3513 11.165 -611 2 45.3118 34.1769 4.28537 -21.2148 -46.3229 -17.5718 -612 2 44.4751 34.4561 3.06273 -18.3812 8.00009 -33.6438 -613 3 44.391 33.6426 2.09905 3.94034 16.0457 30.0851 -614 4 45.6176 35.6832 5.71813 13.2063 -8.66839 -22.6288 -615 4 46.0373 33.4799 3.80083 11.0255 -0.404913 12.3267 -616 2 44.604 33.4055 5.40679 37.9095 -5.49339 -20.8443 -617 2 43.894 32.1911 4.95963 4.52806 -52.0805 -10.2655 -618 3 42.6666 32.0496 5.30411 26.1406 -7.63566 -17.5185 -619 3 44.6473 31.2926 4.419 -30.7677 19.4747 14.2469 -620 4 43.8381 33.9821 5.82617 -35.1808 40.951 30.2942 -621 4 45.3664 33.1691 6.19311 -10.275 -1.0365 4.4818 -622 1 43.9409 35.7078 2.94042 3.22733 -51.5357 -49.9186 -623 2 43.348 36.2006 1.70588 25.8776 -9.12573 -18.8138 -624 2 44.3757 36.8172 0.713167 -7.64912 -13.2689 38.6134 -625 3 44.0628 36.9589 41.4508 -2.41529 3.02373 -15.0868 -626 4 43.9087 36.323 3.69682 4.46748 41.5024 48.5675 -627 4 43.0059 35.3045 1.0879 -7.34341 13.0696 15.3539 -628 2 42.2218 37.2049 1.98307 -32.8685 -0.904888 11.5727 -629 2 41.1062 36.5938 2.90711 22.5622 20.6064 -2.77479 -630 2 39.8757 37.4913 2.92488 9.99264 -5.47282 62.3883 -631 3 39.5847 37.9927 4.02645 -6.88693 1.84466 -13.34 -632 1 39.0832 37.5519 1.86835 -2.09978 -20.426 -31.5908 -633 4 41.7044 37.4782 1.02484 10.2081 4.13789 1.30545 -634 4 42.5649 38.1527 2.49808 3.34998 -7.04672 -12.996 -635 4 41.496 36.4873 3.97615 -8.32458 2.86238 -16.0656 -636 4 40.817 35.592 2.59085 -6.50381 -15.3028 -7.15704 -637 4 39.3467 37.1489 0.943045 -1.18671 2.30285 11.2704 -638 4 38.1024 37.7997 2.00291 -4.61511 13.1634 -1.5169 -639 1 45.5865 37.1913 1.18701 0.34656 3.48246 -50.9957 -640 2 46.5715 37.7193 0.263736 40.0587 13.4866 27.3297 -641 2 47.1476 36.6709 41.2495 -9.99518 -39.8037 -22.9547 -642 3 47.6611 35.6473 41.7682 -3.12622 19.3551 -24.5438 -643 4 45.9505 37.0475 2.10099 0.0710674 -6.02767 36.3056 -644 4 46.0766 38.4733 41.5789 -9.05589 19.6465 -18.4972 -645 2 47.8462 38.4064 1.04164 -24.5048 14.2529 -26.5929 -646 2 47.4036 39.6651 1.82888 -3.7708 6.53308 31.1421 -647 2 48.5926 40.4064 2.51341 13.2626 3.99863 -2.76696 -648 3 49.7104 40.5691 1.98441 -24.6046 -10.5895 -1.86534 -649 1 48.3407 40.8898 3.74779 29.4138 -3.81739 16.8938 -650 4 48.597 38.7482 0.246377 -8.81496 -5.86425 14.2737 -651 4 48.3893 37.7509 1.72975 1.66752 -15.4435 3.74234 -652 4 46.6019 39.4971 2.66308 23.3117 -7.11271 -27.0857 -653 4 46.9261 40.3559 1.12913 -3.21242 13.4997 -7.95635 -654 4 47.3907 40.9351 4.12169 -5.60594 2.69026 7.41827 -655 4 49.1659 41.1473 4.37984 -25.8317 -2.18268 -20.985 -656 1 47.0143 36.8241 39.8589 2.94896 -6.17569 33.9376 -657 2 47.6738 36.0506 38.8108 16.6825 -23.5637 34.6067 -658 2 48.454 37.0258 37.9695 9.24498 -19.2444 17.2828 -659 3 47.9734 37.5867 37.0249 -16.9661 22.5794 -32.933 -660 4 46.3407 37.4883 39.4677 -2.13376 9.43233 0.449621 -661 4 48.4374 35.3321 39.3605 -24.6855 17.1776 -23.0678 -662 2 46.6968 35.2528 37.909 -27.9143 -33.2437 25.7199 -663 2 46.039 33.9895 38.7043 9.93401 10.5983 7.56799 -664 2 46.87 32.6784 38.9289 23.0786 -0.450758 -24.5995 -665 1 47.7656 32.5928 40.0651 -0.0346617 67.7235 50.2506 -666 2 48.5337 31.5574 40.3699 -14.5633 -26.8579 -35.9878 -667 1 48.7282 30.552 39.4879 -2.05986 8.25564 18.106 -668 1 48.8872 31.3858 41.6213 -4.84512 27.348 -3.11289 -669 4 47.2327 34.8627 37.0058 -5.81127 5.13112 -1.60937 -670 4 45.8267 35.9464 37.6192 18.3744 -10.9215 -5.83414 -671 4 45.065 33.6697 38.178 15.3305 12.1509 10.6411 -672 4 45.8045 34.3704 39.7428 -14.1926 -3.74807 -10.9265 -673 4 47.5159 32.4832 38.0006 -21.4463 1.51143 8.96621 -674 4 46.1858 31.8178 39.0967 -9.12823 -0.449275 -15.1225 -675 4 47.7485 33.3794 40.8208 -8.02877 -26.8637 -33.9869 -676 4 48.3609 30.5297 38.5261 -2.43008 2.66571 1.08755 -677 4 49.1746 29.6933 39.8011 5.57148 -11.3344 1.43527 -678 4 48.5595 32.0107 0.447997 -4.49593 6.14729 8.57279 -679 4 49.3675 30.5632 41.8859 20.5825 -37.41 17.1512 -680 1 49.6971 37.2567 38.3612 38.8031 36.8466 -19.9315 -681 2 50.6251 38.1764 37.6375 5.59701 -6.58181 11.8605 -682 2 51.1059 37.476 36.33 -5.39593 -3.52342 3.95062 -683 3 51.4567 36.2851 36.3473 -6.1727 9.88097 2.62067 -684 4 50.1666 36.6257 38.9842 10.5469 -17.0261 18.2142 -685 4 50.0436 39.1015 37.4003 1.48542 -2.85918 -9.88003 -686 2 51.8783 38.6033 38.5414 -14.1699 17.2606 4.5582 -687 2 51.4771 39.4948 39.8067 23.634 -8.13025 9.13717 -688 2 52.8025 39.6936 40.6861 -45.72 0.0787629 30.9804 -689 2 51.0312 40.8873 39.3543 -1.21924 6.71403 17.5275 -690 4 52.6247 39.2003 37.9187 -12.0326 -10.2321 5.24388 -691 4 52.4336 37.7304 38.9418 -1.83231 -8.6555 -7.07863 -692 4 50.6844 38.9864 40.4458 6.67436 6.37453 -9.78056 -693 4 52.9275 38.7652 41.2899 1.57503 4.15297 5.5095 -694 4 52.875 40.6185 41.4124 -9.95772 -27.9304 -22.9777 -695 4 53.6477 39.6981 40.0479 39.2622 9.27083 -23.1198 -696 4 51.882 41.4315 38.8764 -8.78739 -1.58992 -12.4168 -697 4 50.8284 41.5065 40.2813 -10.0843 -5.65437 -12.2377 -698 4 50.1041 40.7893 38.7156 9.84678 12.7352 4.22225 -699 1 51.1335 38.2092 35.1872 23.4477 43.7196 -18.1994 -700 2 51.5372 37.7272 33.8205 5.66277 23.826 53.2621 -701 2 52.816 38.5373 33.39 -13.9696 27.2523 3.91394 -702 3 52.9014 39.7954 33.5824 -9.48934 -35.8428 -1.88315 -703 4 51.0917 39.2914 35.1751 -6.07189 -44.7564 8.7296 -704 4 51.807 36.6734 33.9114 3.67702 -17.8942 -3.77347 -705 2 50.2728 37.942 32.9627 24.5619 2.20768 -27.072 -706 2 49.0946 37.0552 33.3907 -40.4332 32.861 4.12747 -707 2 50.6582 37.6771 31.4819 -4.87136 -12.6088 -15.1928 -708 2 49.1924 35.592 33.2496 18.605 -47.1891 -10.6734 -709 4 50.0222 39.0181 33.0462 -10.0421 3.96713 0.824793 -710 4 48.1822 37.369 32.7965 11.3859 0.507389 5.43773 -711 4 48.766 37.227 34.4352 6.35082 10.8857 5.72377 -712 4 49.7261 37.457 30.8365 21.3715 9.42576 10.5226 -713 4 51.3528 36.7896 31.3856 -11.4398 6.26312 1.5823 -714 4 51.2274 38.5516 31.0485 -10.0605 -6.0953 1.35419 -715 4 50.1827 35.2313 33.6939 -19.2762 -1.86106 -7.31237 -716 4 49.1345 35.3223 32.1629 6.46074 -3.78635 4.92713 -717 4 48.3248 35.0641 33.7333 8.66481 1.90115 0.669024 -718 1 53.7674 37.8522 32.7049 -0.401058 29.0536 2.76503 -719 2 54.8534 38.494 31.9889 21.3589 25.2573 -50.7784 -720 2 0.070256 37.9331 30.5159 -12.6617 -10.513 26.1463 -721 3 0.610536 36.8336 30.3273 -13.153 9.14635 -3.0322 -722 4 53.7049 36.8532 32.6778 5.78014 -33.2974 -6.55066 -723 4 54.4976 39.583 31.7137 12.734 -24.0185 30.659 -724 2 1.32523 38.4582 32.6174 -11.2306 -14.0383 43.8112 -725 2 2.25298 39.4244 31.93 21.239 -3.52493 -6.53852 -726 2 1.82142 40.7594 31.946 9.01925 8.15494 1.3639 -727 2 3.55305 39.1373 31.3858 -52.1121 -37.4601 32.7366 -728 2 2.62719 41.7738 31.436 16.1375 42.966 -9.20235 -729 2 4.2717 40.1621 30.8907 55.019 31.5071 -38.7093 -730 2 3.8753 41.5182 30.8618 10.3374 -30.1635 6.5347 -731 4 1.72137 37.3957 32.6071 -2.968 13.2806 -7.3675 -732 4 1.36361 38.7573 33.7485 -10.0277 -6.08615 -32.1159 -733 4 0.900203 41.04 32.4671 -4.90014 4.47018 0.827909 -734 4 4.05865 38.1292 31.3848 -19.507 10.3261 2.47632 -735 4 2.40669 0.963664 31.507 -12.4107 -17.8541 2.52862 -736 4 5.22734 39.8163 30.4261 -2.17835 18.3508 4.41679 -737 4 4.61313 0.382875 30.4956 -18.9116 -9.53382 4.9162 -738 1 54.5208 38.7001 29.536 -17.794 9.59417 2.44526 -739 2 54.4433 38.3677 28.0932 0.413701 6.77287 11.8816 -740 2 53.8236 36.9714 27.8054 -10.5704 38.9519 24.3324 -741 3 54.2836 36.1684 27.0139 12.3723 -16.7122 -9.38408 -742 4 54.0063 39.582 29.8758 15.9225 -27.1932 -25.0825 -743 4 53.6617 39.0994 27.7122 21.1252 -9.31914 -10.5745 -744 2 0.84771 38.4562 27.3872 5.21129 26.4327 0.415045 -745 4 1.55752 39.2926 27.6564 -22.375 -0.429945 3.27523 -746 4 0.737328 38.5366 26.268 -0.662808 -7.52676 8.67249 -747 4 1.44048 37.5755 27.6711 3.3074 -14.1434 -6.0421 -748 1 52.6712 36.7812 28.4639 -34.4859 10.4254 42.9936 -749 2 51.8461 35.5981 28.5315 7.11639 -32.3641 19.2856 -750 2 52.1287 34.6607 29.761 72.1729 37.4894 -16.6197 -751 3 51.2969 33.8912 30.1393 -37.38 -39.1809 16.7772 -752 4 52.2301 37.5459 29.0797 18.7619 -22.9106 -24.882 -753 4 50.752 35.8045 28.6381 6.6344 10.4547 -3.03351 -754 4 51.9318 34.9661 27.6028 3.27123 7.03186 8.45077 -755 1 53.4041 34.6064 30.3039 -37.1524 -18.2668 23.7743 -756 2 53.8481 33.579 31.3343 19.9058 12.4048 -28.9308 -757 2 53.2753 33.7631 32.7245 -4.20442 17.2631 -10.7202 -758 3 53.3264 34.8931 33.2388 -7.00143 -11.8952 2.65621 -759 4 53.9984 35.4233 30.2821 14.046 11.4873 -9.55867 -760 4 53.5575 32.5679 30.9796 -2.97426 -3.20006 -4.3618 -761 2 0.441949 33.6673 31.397 15.483 24.485 -22.5221 -762 2 1.1159 33.1056 30.111 -2.52249 -22.0361 -11.2405 -763 2 2.65939 33.3504 30.0471 -29.7948 -11.8394 -36.8606 -764 2 3.5253 32.433 30.8659 3.71436 3.74322 35.9681 -765 1 4.92891 32.7835 30.8601 -3.73949 -14.6782 3.94495 -766 4 0.930008 33.1164 32.2052 -10.1795 -8.12889 21.2637 -767 4 0.820281 34.7554 31.5264 -17.1946 -20.5931 1.67355 -768 4 0.726808 33.5631 29.1693 -8.69229 5.5421 6.41341 -769 4 0.816642 32.0044 30.0112 14.0154 14.8269 0.94841 -770 4 2.76655 34.4177 30.2798 16.9839 11.3836 1.64388 -771 4 2.99027 33.2006 28.9712 -4.31169 8.16855 10.4317 -772 4 3.48024 31.3628 30.6286 -9.21502 -9.13385 -9.88849 -773 4 3.14214 32.5157 31.9169 10.307 -3.37241 -3.01155 -774 4 5.38024 32.7641 29.968 4.13535 -6.65161 -12.8027 -775 4 5.44585 32.16 31.4735 7.57437 4.94374 1.68638 -776 4 5.11721 33.7072 31.1652 -0.520286 24.3887 13.7994 -777 1 52.7286 32.6609 33.3217 21.3895 7.82715 -40.48 -778 2 52.3746 32.6765 34.6845 -3.94215 -5.7204 42.1903 -779 2 53.6544 32.9612 35.4718 -32.0777 16.7216 -3.31611 -780 3 54.7101 32.4293 35.2196 26.5529 -12.799 -1.69002 -781 4 52.7346 31.7402 32.8358 -3.66087 10.5856 2.03104 -782 4 51.6553 33.4893 34.886 -4.93781 11.2662 -7.45083 -783 2 51.7389 31.3462 35.1425 36.1525 -8.24878 -2.45066 -784 2 50.4549 31.4357 35.902 -2.56298 9.46411 57.003 -785 2 50.5914 31.9702 37.3969 -4.77582 -10.2539 -35.2763 -786 3 49.9129 32.941 37.7385 4.53321 10.1718 7.36032 -787 1 51.4448 31.3274 38.2318 1.89331 10.2207 20.9211 -788 4 52.4532 30.7011 35.7138 0.934865 4.72627 -2.3237 -789 4 51.5619 30.7887 34.2312 -11.1921 -21.1455 -14.7508 -790 4 50.0197 30.4197 36.0127 -8.03636 -0.273264 -6.56567 -791 4 49.7685 32.1089 35.3545 -11.9583 -2.57651 0.31815 -792 4 51.7323 30.3416 38.1022 2.22495 5.18328 -8.30147 -793 4 51.645 31.7871 39.1631 -4.2657 -12.8631 -21.1898 -794 1 53.54 33.8952 36.4131 -39.2018 -0.531466 -0.79929 -795 2 54.5682 34.2648 37.3102 -29.3437 58.7358 21.9421 -796 2 54.3255 33.5954 38.6431 29.6978 -77.406 0.637438 -797 3 53.3742 33.7807 39.3881 -15.8118 22.9548 5.85491 -798 4 52.6165 34.3686 36.5483 14.9252 -1.63515 2.31459 -799 4 0.525104 33.9954 36.8979 32.3496 -27.0675 -4.05845 -800 2 54.6285 35.827 37.4074 -17.7645 -17.3983 39.0191 -801 2 0.013954 36.4546 36.058 15.6745 -1.04323 18.583 -802 2 0.049019 37.9526 36.293 -63.1087 6.90888 -39.4544 -803 2 1.42802 35.9308 35.6826 4.08802 -6.56861 34.108 -804 4 0.435555 35.9801 38.2063 -13.4425 16.5914 -13.2273 -805 4 53.6198 36.2963 37.798 28.292 -21.2068 -7.80607 -806 4 54.2061 36.2134 35.3084 7.36084 -1.04605 -3.46995 -807 4 54.0713 38.2397 36.8522 27.1057 4.55429 -9.55418 -808 4 54.939 38.4282 35.2643 6.0019 1.58695 18.2366 -809 4 0.927863 38.3313 36.762 28.685 14.2218 21.5028 -810 4 1.30489 34.8989 35.3991 1.43296 -22.664 -21.4406 -811 4 2.25694 35.8344 36.4845 -24.5016 17.8738 -12.6534 -812 4 1.83634 36.4362 34.8335 13.635 15.7788 -26.8996 -813 1 0.008587 32.3758 38.733 13.7846 27.3237 -75.0314 -814 2 54.826 31.3 39.6331 17.4428 -14.6066 45.4768 -815 2 0.455793 31.7866 40.9725 -5.37526 1.66294 14.9859 -816 3 1.60943 32.1773 41.0547 11.2247 3.92934 -7.13086 -817 4 0.661532 32.0877 37.9163 -19.8505 19.9989 33.4434 -818 4 53.7452 31.1425 39.875 0.374502 -5.35979 -15.722 -819 2 0.574437 30.0043 39.0439 11.2157 23.6116 11.9724 -820 2 0.334302 28.7136 39.8578 -22.6665 -11.1233 -21.4622 -821 2 0.695999 28.7 41.3625 12.0844 -36.9796 9.0265 -822 3 54.7253 28.727 0.298109 10.889 15.3071 -4.11946 -823 3 1.91063 28.4506 41.7261 -30.7481 15.8042 -10.4483 -824 4 1.71086 30.1341 39.082 -19.7243 9.32222 0.312381 -825 4 0.358791 29.9926 37.9166 -2.62684 -19.8589 21.79 -826 4 0.882365 27.912 39.2891 -0.232785 0.308618 14.1734 -827 4 54.2301 28.3798 39.7718 17.2545 10.1943 -0.206185 -828 1 54.6325 31.7916 0.156881 38.5875 2.07504 -29.8841 -829 2 54.8631 32.3302 1.45975 7.41407 33.4343 26.7616 -830 2 1.21087 32.0241 2.20189 -33.1211 2.89979 -4.9396 -831 3 1.57835 32.811 3.08735 12.0797 -3.2377 -11.0832 -832 4 53.6756 31.6317 41.8616 -38.5912 -7.03962 0.740029 -833 4 54.9627 33.4927 1.3754 -11.7864 -35.033 -4.32612 -834 2 53.6666 32.0355 2.42828 -17.6969 8.95863 -1.18459 -835 2 52.1933 32.3158 2.0402 15.1012 41.0915 -15.9482 -836 3 51.3911 33.0513 2.74715 36.5037 -34.5123 -13.5772 -837 3 51.9207 32.0348 0.835441 -22.1157 -3.97518 6.29873 -838 4 53.9089 32.5595 3.33158 -2.01457 20.6007 30.7692 -839 4 53.6609 31.0051 2.75768 6.68313 -26.6133 3.27231 -840 1 1.77413 30.8239 1.99288 23.346 -11.0551 12.4557 -841 2 2.99412 30.3649 2.70859 20.7873 20.7026 2.58588 -842 2 4.37767 30.5585 1.9432 -4.58172 12.4342 76.2013 -843 3 5.43315 30.6356 2.6242 -17.4542 -1.84538 -14.1099 -844 4 1.23141 30.1158 1.49013 8.16278 -4.42375 -5.05013 -845 4 3.08709 30.9756 3.71749 -2.54673 -19.312 -31.0286 -846 4 2.99418 29.2776 2.99437 -11.6108 14.2547 -3.21828 -847 1 4.33484 30.73 0.643592 -44.4777 10.1896 -41.2897 -848 2 5.29878 31.2923 41.6537 25.3276 0.744315 3.96016 -849 2 5.54544 32.7486 0.121481 37.2819 -30.872 -27.7426 -850 3 4.68176 33.387 0.67546 -18.5336 28.2868 17.8008 -851 4 3.3891 30.7154 0.224796 5.58966 -1.49205 -0.51948 -852 4 6.30256 30.8588 41.8823 -3.47112 -15.4387 -8.82901 -853 2 4.8423 31.1802 40.1578 47.5835 -21.6785 -9.15502 -854 2 4.71332 29.7742 39.4637 -7.18766 34.2596 -8.85866 -855 2 5.63064 28.6968 40.0034 1.34917 -52.5839 -25.1875 -856 1 5.28494 28.1736 41.3081 -3.70672 3.58414 23.7744 -857 2 6.07557 28.0057 0.492928 -10.4577 4.69864 -29.3733 -858 1 7.37832 28.2278 0.392183 22.9004 -4.79637 26.256 -859 1 5.53705 27.6868 1.66636 -6.4094 -24.443 39.9026 -860 4 5.53303 31.787 39.5095 -0.196101 -2.7377 7.98036 -861 4 3.92152 31.7024 40.0755 -40.4143 20.5365 -6.7059 -862 4 4.89215 29.8961 38.3273 -2.53464 -0.592337 23.8175 -863 4 3.64677 29.4833 39.5295 -2.27017 -8.63927 2.61329 -864 4 6.69627 28.939 39.9328 9.42975 10.3347 -2.35439 -865 4 5.48992 27.7969 39.2806 7.04825 21.6687 20.0754 -866 4 4.27254 28.0467 41.4152 -4.83075 -3.28587 3.65899 -867 4 7.98538 28.2099 41.4852 -8.02405 3.18538 -21.0185 -868 4 7.94047 28.2423 1.24565 0.364194 -0.98827 11.7246 -869 4 4.53186 27.4078 1.78766 14.7644 10.3007 -8.4097 -870 4 6.1013 27.52 2.55737 -8.44391 7.70178 -27.0297 -871 1 6.79596 33.2006 41.6804 -27.9344 8.59735 4.57792 -872 2 7.15148 34.5952 41.8655 -38.9276 -12.1291 -1.68573 -873 2 6.77215 35.2911 40.5652 14.0197 56.9428 51.8707 -874 3 6.49158 34.715 39.5569 -13.5951 -21.5425 -43.0675 -875 4 7.31858 32.7386 40.9072 -2.655 4.76346 14.1821 -876 4 6.52583 35.0505 0.829338 19.3934 -10.3795 -24.0216 -877 2 8.63545 34.7883 0.159249 -4.7809 22.3707 74.7553 -878 3 9.31911 34.1951 41.0459 32.4158 -10.9375 -20.7672 -879 2 9.12239 34.1481 1.54228 -45.3508 12.3646 -39.5443 -880 4 8.86138 35.9031 0.177513 1.59938 -13.4643 1.18346 -881 4 10.1943 34.4871 41.2598 15.0836 -7.29109 -20.5697 -882 4 10.1218 34.4779 1.7295 32.9793 8.82002 13.7556 -883 4 9.1354 33.0404 1.45915 -3.89828 -1.77159 7.54964 -884 4 8.44695 34.5279 2.36236 9.39315 -9.78399 0.0431608 -885 1 6.96309 36.6454 40.6555 -22.2962 -38.3404 -33.8498 -886 2 6.94214 37.5275 39.5132 -15.3576 22.9899 27.1878 -887 2 8.03225 37.1821 38.5547 25.8315 2.87875 -39.3086 -888 3 7.87409 37.2091 37.3037 -11.7489 -2.94068 30.2829 -889 4 7.09017 37.0079 41.5812 4.58243 22.402 24.7274 -890 4 6.01646 37.4072 38.9238 -6.0018 -8.28766 -1.15408 -891 2 7.01182 39.0163 40.0252 -15.3603 -23.3284 55.3652 -892 2 5.61926 39.5384 40.7634 13.0639 11.727 -14.3013 -893 2 5.74741 41.0778 41.0735 34.612 -8.65688 -61.1535 -894 2 4.30485 39.278 39.9775 33.2171 6.29002 -24.4772 -895 4 7.23253 39.6079 39.1676 9.01238 29.648 -28.6912 -896 4 7.91826 39.1206 40.7867 -28.368 0.120823 -25.2036 -897 4 5.4532 38.9933 41.7239 13.5286 -1.18368 4.70417 -898 4 4.88701 41.4539 41.5866 -22.2749 9.39049 21.0562 -899 4 5.89633 41.7578 40.1185 -8.19165 -26.548 25.276 -900 4 6.67066 41.2365 41.6556 -0.494064 4.57358 11.7906 -901 4 4.18164 39.8273 38.9933 8.48456 -7.17755 11.4037 -902 4 3.44244 39.5261 40.5797 -17.807 1.17877 7.97341 -903 4 4.2824 38.1939 39.7929 -10.4691 -3.8299 -8.01616 -904 1 9.23783 36.8543 39.0653 -4.40645 21.0053 19.4908 -905 2 10.3275 36.5838 38.1582 31.0816 -25.3995 62.8998 -906 2 10.2997 35.2224 37.4613 6.04581 38.1949 -0.210763 -907 3 11.0208 35.1071 36.4655 -6.3656 -14.3958 -11.0193 -908 4 9.51333 37.1441 40.0706 -14.9717 -14.5173 -38.8343 -909 4 10.386 37.3498 37.3821 -1.67567 12.3369 -13.0834 -910 2 11.6168 36.6846 39.0604 -5.3878 -32.5356 -23.0633 -911 3 11.6818 35.7254 40.0985 -18.2206 13.507 16.8431 -912 4 11.7318 37.6647 39.5052 6.99822 20.9023 2.76215 -913 4 12.4798 36.426 38.4299 12.1644 16.7594 -11.1747 -914 4 12.2479 35.0511 39.7675 10.0745 -20.8981 -3.76732 -915 1 9.3909 34.3264 37.8733 -42.427 -15.3638 26.6935 -916 2 8.99216 33.1557 37.0842 54.1918 17.4661 1.85655 -917 2 8.44195 33.5842 35.7305 -20.833 60.571 55.2199 -918 3 8.45395 32.8337 34.8033 7.91235 -41.3122 -40.5547 -919 4 8.901 34.4208 38.8182 18.72 -3.57692 -25.7233 -920 4 10.0039 32.69 36.8915 -15.1884 -12.4868 -9.34361 -921 2 8.05349 32.1507 37.7268 -1.844 -26.1592 7.76215 -922 2 8.63612 31.2276 38.7905 8.98886 15.2457 3.52798 -923 3 8.28567 31.4376 39.9878 9.18033 -14.5703 -9.08999 -924 3 9.46172 30.3301 38.4185 -14.4281 10.7169 -2.66077 -925 4 7.57008 31.4717 36.9797 -4.32683 11.3708 2.99534 -926 4 7.24557 32.7088 38.1955 -18.7592 7.98312 4.87833 -927 1 7.76821 34.7903 35.7104 -0.921577 -49.5867 -7.77983 -928 2 7.00589 35.2713 34.5947 28.4194 33.7396 -49.4054 -929 2 7.85162 36.3274 33.7967 14.0615 10.3677 50.876 -930 3 7.59561 36.677 32.642 -11.5138 -12.0529 -0.0837023 -931 4 7.64044 35.3156 36.5601 -2.79577 12.0246 16.4277 -932 4 6.95142 34.464 33.8059 -8.74679 1.13416 10.6726 -933 2 5.60472 35.8897 34.9384 -10.82 -34.5279 -29.2679 -934 2 4.80808 34.6511 35.4252 21.4048 19.1212 -24.4535 -935 2 4.58939 34.449 36.7896 -8.79739 7.49237 6.99756 -936 2 4.44707 33.6361 34.4808 -22.1156 13.6667 13.0483 -937 2 3.78406 33.375 37.155 10.056 16.8174 60.0349 -938 2 3.57928 32.5992 34.8543 35.6828 20.067 14.4288 -939 2 3.32606 32.5122 36.2195 -36.4887 -32.5961 -12.2866 -940 3 2.43989 31.6229 36.7148 -5.7594 -17.052 -20.0699 -941 4 5.14192 36.3424 33.9886 5.39246 -18.3577 14.2305 -942 4 5.60606 36.7583 35.5989 7.01287 1.52307 19.367 -943 4 4.94491 35.1783 37.5598 -4.47364 -7.92921 -7.91861 -944 4 4.66046 33.7427 33.4202 4.87397 4.4658 -8.40916 -945 4 3.45738 33.1597 38.2449 15.2806 17.1295 -26.8514 -946 4 3.26795 31.828 34.148 -6.61111 -3.61155 -4.72788 -947 4 2.1868 31.1622 35.9134 -6.91994 -9.03483 11.406 -948 1 8.90205 36.8981 34.5027 -17.2687 17.5401 -60.9896 -949 2 9.70361 38.0134 33.9387 24.2231 -52.0812 37.3823 -950 2 8.8546 39.1711 33.5701 14.7092 18.0593 -4.53516 -951 3 9.06515 39.7643 32.526 6.45085 3.58457 -7.26619 -952 4 9.11675 36.6435 35.4518 3.62665 -3.0608 21.1339 -953 4 10.3861 38.3235 34.818 -10.2978 3.44266 -21.7419 -954 2 10.5787 37.5562 32.7307 -21.6135 -30.8037 4.74181 -955 2 11.6892 38.5091 32.4223 15.379 -13.1594 38.9153 -956 3 11.683 39.1804 31.4042 4.19267 20.0472 -18.4805 -957 1 12.6852 38.53 33.3751 41.3863 26.0224 -13.8263 -958 4 9.85905 37.4261 31.8504 20.0453 2.40541 7.8736 -959 4 11.053 36.5467 32.9319 -7.17885 8.97611 -4.2567 -960 4 12.817 37.8369 34.166 -15.4043 12.1891 -16.4176 -961 4 13.5001 39.2408 33.2564 -39.0039 -25.8302 4.81098 -962 1 7.96197 39.5631 34.4599 -33.9246 23.5433 37.1278 -963 2 7.21007 40.8276 34.5568 -18.3646 -15.2096 -14.7898 -964 2 8.22007 41.896 34.9201 0.758716 14.3361 -6.26955 -965 3 8.97663 41.7874 35.871 13.0919 -8.40756 13.8683 -966 4 7.83943 39.0508 35.3409 8.95409 -9.59767 0.690263 -967 4 6.70734 41.0591 33.5261 17.9743 -2.28149 22.8597 -968 2 6.0301 40.6247 35.6674 21.3841 11.5647 -11.8815 -969 2 4.89974 39.9794 34.8247 17.8968 2.41192 -27.2216 -970 2 5.64567 41.9074 36.4174 -5.31946 16.9228 -22.0167 -971 2 3.85064 39.271 35.6143 -7.9417 -14.8054 48.1955 -972 4 6.41951 40.0018 36.4929 2.02391 -20.04 -2.41117 -973 4 5.36435 39.2019 34.126 -8.73918 7.93575 11.5905 -974 4 4.48342 40.7424 34.1094 -6.00744 -5.42447 8.5897 -975 4 5.00487 41.8434 37.3074 -11.5574 -14.3762 1.01334 -976 4 5.12929 0.689353 35.6946 7.17582 1.37977 8.89479 -977 4 6.56067 0.460605 36.8355 2.18467 8.54142 -3.2903 -978 4 3.23423 39.9796 36.2601 8.91814 -10.815 -11.4927 -979 4 4.38489 38.5352 36.333 -17.3309 14.265 -14.1697 -980 4 3.16246 38.6765 34.9814 -1.3822 0.0882741 -1.23744 -981 1 8.27901 1.09677 34.1745 -17.8694 -35.8502 15.8719 -982 2 9.1495 2.17731 34.4611 25.5007 24.1899 -15.5427 -983 2 8.44305 3.45517 34.8181 7.33507 13.3767 -14.0082 -984 3 7.22584 3.58853 34.5952 14.73 6.44535 13.4701 -985 4 7.64387 1.07834 33.3925 -5.10967 17.8437 -25.4682 -986 4 9.72616 1.98981 35.3795 6.67437 -11.367 8.50474 -987 2 10.1416 2.3939 33.2727 7.80857 1.28792 -5.65283 -988 2 11.1754 1.27875 33.0535 -29.5709 -1.62172 8.74553 -989 2 12.298 1.25902 34.0434 45.8123 -20.4226 -15.8942 -990 3 13.4264 1.60062 33.6211 -9.09849 2.20405 14.6225 -991 1 12.1286 0.499484 35.1615 13.5856 38.0862 1.93866 -992 4 10.7117 3.33658 33.4062 0.0269402 1.80508 0.780117 -993 4 9.62868 2.54332 32.3022 -11.3844 1.67988 3.84081 -994 4 11.6026 1.39089 32.0291 1.1132 -6.32648 1.88738 -995 4 10.6463 0.304077 33.1517 4.80745 -4.48978 -13.057 -996 4 11.1623 0.324257 35.4356 -7.1112 -9.24345 12.7946 -997 4 12.86 0.645961 35.8984 -11.3978 -13.87 -11.7385 -998 1 9.29061 4.442 35.2624 -22.3208 40.9019 24.8252 -999 2 8.81116 5.82611 35.6978 -18.3987 -9.60009 -41.1421 -1000 2 7.90959 6.36535 34.5148 35.1086 -14.4229 -13.6713 -1001 3 8.27789 6.14754 33.3333 -13.6173 9.04219 21.6414 -1002 4 10.326 4.35425 35.3433 -15.5473 -10.8229 -5.10085 -1003 4 8.07437 5.70026 36.5174 9.02025 -1.47766 10.124 -1004 2 9.99583 6.76313 36.1565 -25.1565 20.6308 -28.9867 -1005 2 11.135 6.93617 35.1361 2.62363 -10.5046 6.46017 -1006 2 12.4502 7.42969 35.8581 -25.4448 -27.2564 -27.4451 -1007 2 12.3858 8.85842 36.3442 -55.084 26.5775 24.6628 -1008 1 13.634 9.41318 36.7712 33.8844 -44.8334 11.878 -1009 4 10.2929 6.30703 37.0832 24.0012 -1.96783 25.2264 -1010 4 9.73373 7.84957 36.4159 -14.1304 -26.7275 0.147522 -1011 4 10.8081 7.68154 34.3572 5.16283 -4.02502 4.78839 -1012 4 11.298 5.9636 34.5725 5.23915 16.0099 8.41141 -1013 4 13.159 7.4137 35.035 25.5516 -2.14082 -10.0364 -1014 4 12.8083 6.68649 36.6117 -1.06896 6.08822 -0.205097 -1015 4 11.642 8.94716 37.2538 22.1051 -1.45756 -27.4817 -1016 4 11.9592 9.50431 35.5025 9.97141 -3.64215 15.7788 -1017 4 13.6538 10.3723 37.0555 -8.09423 13.3796 3.79584 -1018 4 14.2885 9.3339 36.0056 2.60625 13.8446 -5.44478 -1019 4 14.0928 8.83644 37.5176 -15.06 24.3666 -13.6607 -1020 1 6.73429 6.959 34.8261 9.36917 -0.537504 -3.37326 -1021 2 5.68914 7.48312 33.9811 -11.6093 0.198368 -29.7566 -1022 2 4.72257 6.43001 33.3633 23.9678 57.8121 29.6097 -1023 3 3.69345 6.80336 32.8731 -41.5354 18.269 -25.9458 -1024 4 6.5403 7.08067 35.8075 -8.4584 6.57489 23.7637 -1025 4 4.95828 8.08289 34.6274 18.5559 -1.63885 -10.0577 -1026 2 6.30301 8.33887 32.7628 1.61604 -0.894199 46.3222 -1027 2 6.96232 9.68302 33.2113 17.5203 -12.0258 -13.4607 -1028 2 6.11334 10.8061 33.8152 -7.60378 12.6352 19.0416 -1029 3 5.31496 11.4419 33.0422 10.0378 -5.26853 5.86857 -1030 3 6.28181 11.1536 35.05 3.36103 -18.7342 -31.8229 -1031 4 5.5011 8.60814 32.0808 -13.4162 -1.3456 -15.0867 -1032 4 7.01778 7.64283 32.2215 -8.51236 18.4517 -1.11608 -1033 4 7.483 10.1113 32.3225 -5.01151 2.49106 -4.14977 -1034 4 7.84021 9.44334 33.8428 -3.17944 -2.15711 8.7111 -1035 1 4.98957 5.17145 33.408 31.7294 -73.5208 5.3031 -1036 2 4.03057 4.12888 32.9492 20.6717 -14.7005 -20.2168 -1037 2 2.6598 4.36206 33.592 -3.0444 -3.65398 -36.823 -1038 3 2.63368 4.6245 34.7729 -17.9957 9.5377 28.5993 -1039 4 5.93287 4.88555 33.7778 -25.4301 -4.21673 -10.3446 -1040 4 3.97065 4.08898 31.7849 -0.621936 10.7688 28.6704 -1041 2 4.54797 2.73693 33.4323 -9.78314 13.2989 35.3654 -1042 3 5.7396 2.38581 32.8061 3.87836 -1.00687 -28.9834 -1043 4 3.83029 1.94659 33.1597 -9.96533 -6.0451 7.8725 -1044 4 4.7579 2.77573 34.5879 -14.8326 -6.64015 -28.538 -1045 4 6.39905 2.57303 33.4496 16.1931 5.10903 8.49462 -1046 1 1.55493 4.20465 32.7937 9.73391 7.12296 -2.26043 -1047 2 0.143907 4.28394 33.2313 13.768 -18.1657 13.0528 -1048 2 54.6863 2.83094 33.3214 -0.0746788 -18.1404 42.9803 -1049 3 54.7972 2.04898 32.3833 -5.36381 -6.57018 -20.4337 -1050 4 1.75536 3.84626 31.8337 -17.5999 5.97734 12.9737 -1051 4 0.145346 4.72929 34.2869 -5.52407 -1.41906 -16.7638 -1052 2 54.0936 4.99047 32.3072 48.5491 53.4262 27.9832 -1053 3 54.4431 6.39026 32.3568 26.5828 -36.1107 8.98461 -1054 2 52.7233 5.01429 32.8691 -55.1486 3.23885 2.70228 -1055 4 54.1505 4.66496 31.2868 0.0550865 -16.0071 -29.7017 -1056 4 53.7986 6.85268 31.88 -20.6445 25.8891 -20.893 -1057 4 52.6197 5.54793 33.8322 5.93951 -5.3567 9.34144 -1058 4 52.3467 3.98503 32.9647 -9.06602 -5.34833 4.63236 -1059 4 51.9747 5.55452 32.2255 9.49609 -7.51028 -3.22615 -1060 1 54.1802 2.39741 34.5222 -14.8232 32.9081 27.5353 -1061 2 53.4465 1.14651 34.785 33.9277 15.1 -62.0226 -1062 2 52 1.44639 34.4384 -40.9452 -8.29472 -14.3346 -1063 3 51.516 2.52365 34.8247 -1.26544 -9.47139 -8.9244 -1064 4 54.0715 3.07846 35.3501 9.6448 -17.4772 -31.2652 -1065 4 53.9076 0.391021 34.1043 -10.2836 -7.20705 -0.475865 -1066 2 53.6069 0.737389 36.2058 40.6624 3.41232 47.0409 -1067 2 0.15698 0.778637 36.8849 -22.9225 14.5477 7.59965 -1068 2 0.184063 0.045177 38.2545 -1.48959 -18.0819 6.68284 -1069 2 1.19764 0.213126 35.924 -17.0247 17.4527 -16.4279 -1070 4 53.1759 41.6554 36.3315 -4.28574 -19.6707 2.88188 -1071 4 52.9166 1.40322 36.7387 0.80484 4.57892 22.2756 -1072 4 0.570353 1.84035 37.1024 -27.1105 -11.6335 -5.02718 -1073 4 54.3756 0.329349 38.9832 1.77724 8.98271 -8.45905 -1074 4 1.16626 0.241414 38.7954 -11.8595 -7.79047 -8.4361 -1075 4 0.0237 40.841 38.1265 8.8292 11.305 -0.869273 -1076 4 2.1582 0.044818 36.439 11.171 3.86438 -4.7836 -1077 4 1.22244 1.0066 35.1406 25.1303 -1.4606 -0.0516333 -1078 4 0.965216 41.2564 35.3038 -8.75588 -20.9773 6.66787 -1079 1 51.2089 0.49816 33.7614 57.6433 8.13256 28.0245 -1080 2 49.794 0.627079 33.5149 3.58551 37.6409 23.5907 -1081 2 49.1504 41.7362 34.5845 -39.3958 -31.0429 53.6988 -1082 3 49.3072 40.5133 34.7023 12.9245 12.8492 -11.6005 -1083 4 51.5663 41.4343 33.8516 -6.054 3.49016 -14.1934 -1084 4 49.5236 1.72635 33.6347 -1.89472 -11.9516 -1.26615 -1085 2 49.2899 0.093076 32.2111 -20.0469 10.239 -57.1496 -1086 2 49.5504 1.0758 31.0546 44.1484 5.96661 -35.419 -1087 1 48.7105 2.02971 30.4517 -2.34523 -25.3315 39.2373 -1088 2 50.7977 1.22066 30.3277 -75.7848 7.88288 4.96893 -1089 2 49.299 2.59293 29.3763 -23.865 8.39496 11.0232 -1090 1 50.5677 2.14293 29.3127 -12.36 -15.4034 27.3398 -1091 4 48.1533 41.8436 32.187 18.4481 1.21563 9.00361 -1092 4 49.725 40.9798 32.0543 -2.35302 7.24771 -7.56512 -1093 4 47.7373 2.26457 30.8018 19.6426 -7.09987 -8.69392 -1094 4 51.6402 0.582035 30.3922 15.3203 -1.97636 0.19948 -1095 4 48.6832 3.25559 28.7541 24.649 -5.28154 -1.94766 -1096 4 51.2124 2.39582 28.5799 18.4236 6.97779 -14.3308 -1097 1 48.3633 0.438016 35.503 -1.69139 30.1001 11.6909 -1098 2 47.6687 41.7006 36.6492 0.613805 18.6924 -40.9612 -1099 2 46.264 41.3694 36.1307 -7.02361 -30.4834 5.87484 -1100 3 45.3463 0.246853 35.8895 18.8914 5.06283 8.3795 -1101 4 48.1281 1.45816 35.4039 5.5506 -16.4063 -0.101422 -1102 4 48.2062 40.7837 36.9784 6.36967 -2.21031 -8.42979 -1103 2 47.5958 0.687745 37.8565 -25.4558 59.2473 29.5222 -1104 2 46.6931 0.064749 39.0402 -2.78345 4.00632 18.8053 -1105 2 47.0383 40.4557 39.4221 -33.2538 18.6268 -20.4936 -1106 2 46.93 0.927044 40.3419 31.4794 -11.2994 1.29194 -1107 4 47.1354 1.76149 37.5629 9.48386 -42.5729 7.15928 -1108 4 48.6298 0.997945 38.2155 -14.6806 -19.3715 -2.98409 -1109 4 45.5391 0.148422 38.8474 30.3772 -4.98305 -7.99897 -1110 4 47.9695 40.2725 39.9165 32.6255 3.33763 11.188 -1111 4 46.9967 39.7545 38.5575 0.158611 5.44488 0.559019 -1112 4 46.2719 40.0836 40.1333 -2.82757 0.291607 -0.331179 -1113 4 48.0832 1.04093 40.5802 -35.3824 -1.71169 -8.39188 -1114 4 46.4823 0.388091 41.2333 0.118939 13.4124 -7.57083 -1115 4 46.4764 1.95182 40.2253 3.79994 -8.06745 5.67231 -1116 1 46.1155 40.0363 35.9994 32.2071 3.49142 -20.6914 -1117 2 44.9353 39.2817 35.7114 0.014229 -40.6503 61.2515 -1118 2 44.4179 38.8949 37.157 4.06758 -27.6469 18.473 -1119 3 45.1574 38.4668 38.0935 -15.0116 19.769 -34.2637 -1120 4 46.9934 39.487 36.0733 -14.8983 -9.5139 0.794979 -1121 4 44.1193 39.9156 35.4266 -15.9448 22.0113 -37.9939 -1122 2 45.2307 37.9502 34.8403 3.73878 29.7444 42.1248 -1123 2 44.043 37.0324 34.841 -52.9272 -13.7306 14.9234 -1124 2 45.6185 38.368 33.4399 7.42128 1.51593 -38.9882 -1125 4 46.0406 37.394 35.3664 8.69137 1.61483 -3.86581 -1126 4 43.4486 36.945 35.811 20.0159 3.18287 -12.2628 -1127 4 44.3645 35.9957 34.6605 0.118723 -8.68919 -11.9568 -1128 4 43.2413 37.3473 34.1301 7.80666 -3.9283 -7.25571 -1129 4 46.619 38.86 33.4411 -0.357581 -2.40345 0.816384 -1130 4 44.931 39.1517 33.0584 -3.3954 -0.0150932 -1.42103 -1131 4 45.65 37.5606 32.6192 -0.759822 9.78394 24.304 -1132 1 43.0637 38.9039 37.3301 16.2039 -1.11298 52.5829 -1133 2 42.3901 38.4825 38.6382 8.13363 32.9232 -36.228 -1134 2 41.8706 37.0909 38.467 10.8397 -12.8704 71.8875 -1135 3 41.4837 36.7016 37.4073 -23.2793 -18.8499 -56.9312 -1136 4 42.5052 38.9697 36.5072 -31.8536 4.61581 -21.2592 -1137 4 43.1805 38.4127 39.3754 18.2924 -0.774441 22.1039 -1138 2 41.3003 39.5089 39.1545 11.9555 -3.56475 0.849013 -1139 2 41.9844 40.8891 39.6202 11.8289 -38.672 35.4909 -1140 2 41.1032 0.170603 39.4187 0.299182 35.0028 -21.1028 -1141 2 42.4599 40.8175 41.1074 30.4283 -6.43954 -3.58257 -1142 4 40.7378 39.0113 40.0259 3.55617 13.764 -16.8053 -1143 4 40.5882 39.6834 38.2893 4.7664 -2.44084 15.6093 -1144 4 42.9174 41.0251 39.0897 16.4872 7.11459 -27.4623 -1145 4 41.5448 1.21778 39.6878 -5.64292 -30.3916 -9.38981 -1146 4 40.1969 0.063548 40.0003 -21.2204 -0.202137 11.1399 -1147 4 40.8028 0.152067 38.3319 -0.566182 12.1591 9.51378 -1148 4 41.6814 40.5448 41.8308 -8.42244 -8.91154 4.32363 -1149 4 42.887 41.7652 41.4977 -6.37808 7.37928 -6.87517 -1150 4 43.378 40.1338 41.1957 -24.337 0.845851 0.000130478 -1151 1 41.833 36.287 39.5864 -11.7269 -9.12911 -32.1296 -1152 2 41.2021 34.942 39.6247 -13.3362 -7.3841 -33.9439 -1153 2 39.8438 35.1095 40.3167 -2.23182 -18.8086 0.488263 -1154 3 39.8319 35.4679 41.5133 -14.6884 5.15074 -23.9167 -1155 4 42.1857 36.6275 40.4819 6.41783 1.01312 8.70708 -1156 4 41.0734 34.4248 38.4971 0.391294 34.8961 43.783 -1157 2 42.0436 33.9307 40.4129 10.4134 -33.9193 29.8386 -1158 2 41.3224 32.6645 41.0046 18.9395 -8.84266 -15.0635 -1159 2 42.1741 31.41 41.1086 26.4224 -37.0889 -5.20117 -1160 1 43.3231 31.527 0.12404 8.16009 54.2467 4.49909 -1161 2 44.392 30.7336 0.312631 -11.8213 -13.5239 -25.8004 -1162 1 44.683 29.6211 41.5456 -0.875823 -13.5136 -9.93246 -1163 1 45.3567 31.1357 1.10637 -40.5913 52.4111 16.4216 -1164 4 42.6035 34.3028 41.3288 -3.49471 12.9719 -23.3931 -1165 4 42.7742 33.539 39.6653 10.0701 4.50298 5.32726 -1166 4 40.5106 32.3417 40.3808 -25.7726 1.2565 -24.6898 -1167 4 40.8602 32.7415 0.05618 -15.4481 23.3498 31.3369 -1168 4 42.5775 31.2408 40.0556 -4.97325 -9.97334 14.9806 -1169 4 41.5239 30.4863 41.4302 18.1675 25.5375 -11.7586 -1170 4 43.4773 32.5278 0.495625 -12.2609 -36.3484 -6.98406 -1171 4 44.1847 29.2591 40.6938 -0.904676 10.2844 18.7349 -1172 4 45.5197 29.0942 41.8602 -5.70345 -5.08504 -8.10101 -1173 4 45.1981 31.9946 1.67722 9.89922 -9.52065 -4.53153 -1174 4 46.1063 30.5613 1.39407 36.7186 -26.409 10.0907 -1175 1 38.7328 34.6894 39.6013 4.46457 11.7984 -0.102478 -1176 2 37.3765 34.7683 40.1611 -21.3466 -3.56213 -4.53749 -1177 2 37.2086 33.6902 41.246 35.3807 -34.3386 -58.3615 -1178 3 37.7056 32.5617 40.9531 -12.3371 14.3328 36.9617 -1179 4 38.7903 34.2139 38.6548 1.70782 19.6852 25.699 -1180 4 37.2103 35.7436 40.6571 5.74575 10.1154 -0.0963519 -1181 2 36.2415 34.546 39.0669 -3.18027 -0.0437456 15.212 -1182 2 36.1408 35.6492 37.9204 39.4301 -27.8538 10.4422 -1183 2 35.3755 35.0392 36.7616 2.61616 7.91146 -44.6699 -1184 2 35.4893 36.9279 38.4153 -43.6456 26.6605 -35.0263 -1185 4 35.2587 34.5127 39.627 5.22859 0.340849 -7.95454 -1186 4 36.3572 33.4874 38.6664 0.260323 14.7009 0.217726 -1187 4 37.2087 35.8382 37.5664 -16.1128 3.65721 5.42823 -1188 4 35.4477 35.6456 35.7653 9.36321 -17.9472 26.5571 -1189 4 34.3056 35.0154 36.9225 -21.8403 -4.8414 12.2215 -1190 4 35.6878 33.9672 36.6241 -0.675121 9.51327 -11.2908 -1191 4 35.3533 37.7352 37.5449 14.646 -26.9923 30.0517 -1192 4 36.0883 37.365 39.2255 0.238586 8.99863 9.94523 -1193 4 34.398 36.7236 38.7331 27.4296 3.60145 2.66053 -1194 1 36.5178 33.9861 0.43319 -0.886806 18.5628 10.9627 -1195 2 36.4316 33.2481 1.68402 -23.714 -26.6299 -2.13495 -1196 2 35.1244 33.7124 2.42366 15.5385 -30.3313 2.36588 -1197 3 34.7644 34.9026 2.51705 2.20922 -14.5348 -10.7235 -1198 4 35.9714 34.8641 0.38304 3.21168 -9.87759 6.15105 -1199 4 36.3983 32.0948 1.44989 -1.82422 33.6343 5.26777 -1200 2 37.6595 33.5578 2.59019 11.8109 -15.526 -8.95992 -1201 2 37.7925 32.6548 3.8947 -1.46637 37.0951 -40.7395 -1202 2 39.0729 32.9162 4.76145 9.33062 17.9701 -6.69315 -1203 1 39.1272 34.3057 5.34055 -12.0513 -47.2871 -14.6565 -1204 2 40.0361 34.6964 6.22226 19.4309 2.99614 33.8109 -1205 1 41.0505 33.9844 6.76852 5.72064 -28.58 -41.8643 -1206 1 39.7581 35.8909 6.75898 -16.291 -41.0737 -43.8581 -1207 4 37.6558 34.6526 2.69615 5.74115 8.80853 20.4616 -1208 4 38.5677 33.342 1.97837 2.62182 1.38243 0.976295 -1209 4 37.7082 31.6119 3.52088 7.51898 -7.43262 10.1799 -1210 4 36.8684 32.8569 4.46033 -3.22235 -4.22142 15.6354 -1211 4 40.0987 32.7161 4.26669 -27.6432 -2.90908 0.926336 -1212 4 38.962 32.1623 5.56307 10.4764 0.325422 12.3641 -1213 4 38.2956 34.9173 5.26655 4.54825 -8.39051 -8.34855 -1214 4 41.5169 33.1039 6.38476 -28.6266 25.8655 1.14646 -1215 4 41.608 34.3491 7.51377 7.8916 19.9746 23.1278 -1216 4 38.9281 36.336 6.40181 -18.5651 19.0558 1.42199 -1217 4 40.2702 36.4189 7.40653 35.8571 19.9594 40.0309 -1218 1 34.4344 32.6714 2.9841 11.9274 27.4669 5.1488 -1219 2 33.2874 32.9292 3.81699 -8.08564 -7.68863 -5.88537 -1220 2 32.3224 31.7651 3.90854 -17.2979 -17.3182 38.1098 -1221 3 31.6331 31.611 4.98833 24.1293 6.49939 -41.9496 -1222 4 34.8176 31.7057 3.00707 -6.83555 3.8884 -0.368261 -1223 4 33.5991 33.291 4.83995 -4.39941 -8.915 -13.4113 -1224 4 32.6658 33.7351 3.38441 -0.220857 8.92322 -1.65762 -1225 1 32.2676 30.8833 2.86064 7.18924 -6.28537 -11.1453 -1226 2 31.5304 29.6622 2.84554 -44.3988 -8.55194 41.4736 -1227 2 32.0114 28.4719 1.98523 24.1065 42.5964 20.3644 -1228 3 31.2338 27.9142 1.1781 -2.45095 -15.5808 -11.9787 -1229 4 32.835 30.9065 1.99868 7.60542 11.1676 6.22148 -1230 4 31.4977 29.325 3.94534 -1.848 -5.68036 -21.1002 -1231 4 30.428 29.9278 2.63242 23.021 -11.1829 0.219584 -1232 3 33.2484 28.1785 2.03016 -12.1294 -5.65166 -6.61988 -1233 6 29.6841 33.0367 2.60309 -21.6771 -19.3453 -3.47113 -1234 4 28.7948 33.122 2.96731 -0.0142705 6.34055 1.55972 -1235 4 29.6278 32.12 2.27587 17.6678 13.2788 -5.74715 -1236 6 1.91248 24.7582 28.0699 4.20875 0.224039 17.8866 -1237 4 1.01839 24.445 28.2798 3.51323 0.855994 -2.65004 -1238 4 2.43926 24.5752 28.8738 -5.90795 -3.90565 -13.7536 -1239 6 8.97597 35.4266 7.06834 5.04 -9.06312 -1.25332 -1240 4 8.25108 36.0541 6.94232 -0.597114 -1.88223 0.564045 -1241 4 9.78632 35.9205 6.90416 2.6498 8.25727 -2.9232 -1242 6 37.9306 35.2271 23.5275 -29.4197 8.6633 8.88923 -1243 4 37.6331 35.3765 22.6307 -13.538 -1.59668 -6.74716 -1244 4 38.842 35.1051 23.4294 41.2281 -9.97035 -1.96517 -1245 6 11.37 34.6061 20.3231 29.8185 18.8627 -18.7977 -1246 4 10.4583 34.7066 20.5358 -23.2141 -5.0309 12.4901 -1247 4 11.7775 33.9686 20.9051 -0.738527 -14.291 8.66526 -1248 6 3.04799 13.1152 13.5136 35.0099 19.4917 13.0876 -1249 4 2.1896 12.8159 13.7818 -12.1985 -3.35561 6.33527 -1250 4 3.35102 13.7724 14.1976 -9.84998 -14.2313 -17.3692 -1251 6 9.17749 22.3786 24.885 -4.81993 3.49977 17.5169 -1252 4 8.99718 21.9861 24.0258 2.67933 0.293026 -6.97176 -1253 4 8.3097 22.5185 25.3032 2.93356 -2.2731 -6.67367 -1254 6 31.1417 36.1188 7.44168 3.96214 -4.62609 4.57576 -1255 4 30.9859 35.1633 7.26174 3.91063 19.8072 -8.10584 -1256 4 31.8759 36.4086 6.86762 -9.43736 -11.0335 0.220205 -1257 6 20.3122 0.171955 30.1364 24.228 8.43021 7.74329 -1258 4 20.1467 1.09565 29.8896 -9.06662 -5.17995 0.122132 -1259 4 21.2388 0.205679 30.4532 -11.6638 -2.99571 -4.85501 -1260 6 32.6752 3.01477 5.14905 7.73556 0.409651 25.0992 -1261 4 32.0607 2.27652 4.98052 6.16059 10.1356 9.58904 -1262 4 32.7887 3.0902 6.13894 -10.3787 -11.0045 -24.4474 -1263 6 26.2394 8.28697 11.5977 20.1187 4.68976 23.8355 -1264 4 26.2546 7.39802 11.997 -1.81228 7.23555 -2.12718 -1265 4 26.8422 8.82061 12.1901 -18.4274 -19.7459 -23.7973 -1266 6 1.08156 20.2558 0.892389 0.445896 -40.4816 -11.3523 -1267 4 0.921065 19.2784 0.845371 -9.22979 28.4068 22.5673 -1268 4 1.8129 20.2775 0.290341 19.5395 18.0975 -11.5753 -1269 6 29.152 22.9159 1.42964 -10.353 11.3862 1.77115 -1270 4 28.6638 23.7219 1.70393 12.045 -15.0113 -5.27942 -1271 4 29.6471 22.6066 2.20087 0.367353 7.17244 2.17898 -1272 6 34.1439 34.8173 6.47837 -14.6134 34.7664 -13.6599 -1273 4 34.8234 34.3556 6.01831 17.3611 -13.8412 -2.82442 -1274 4 33.8746 34.3136 7.2252 -0.385324 -14.0922 18.4225 -1275 6 25.1602 37.1811 26.5285 37.3138 -10.4299 -24.6025 -1276 4 24.6611 37.8475 26.9305 -29.1138 25.753 30.5337 -1277 4 25.9902 37.6718 26.3423 -2.02618 -10.7722 -5.27175 -1278 6 14.5359 22.233 15.6757 -38.1082 -52.4317 -17.2355 -1279 4 14.0373 21.3219 15.6008 31.4468 51.1923 15.0921 -1280 4 14.2115 22.7284 14.9124 6.42666 2.88962 4.6194 -1281 6 2.85765 5.85542 4.07926 -11.0889 31.9932 11.5474 -1282 4 3.43051 5.71014 4.8302 4.50985 -17.8875 11.7313 -1283 4 2.47546 6.74142 4.27679 -1.8522 -19.462 -7.62003 -1284 6 27.6173 26.7153 22.7048 3.02536 -24.7668 37.2 -1285 4 26.7794 26.2561 22.7471 -5.49099 -10.4557 3.23975 -1286 4 27.5338 27.2427 21.9498 -2.81898 29.5538 -40.3285 -1287 6 17.7815 0.60275 22.3967 -9.44347 22.192 16.8557 -1288 4 17.1106 0.664367 23.1174 8.05472 -4.70436 -13.4643 -1289 4 18.0991 1.53066 22.3547 -2.50437 -12.3009 -7.04453 -1290 6 8.08803 9.43976 10.5674 4.80966 -47.9744 28.0614 -1291 4 8.01535 10.2871 10.1695 -8.25869 32.7817 1.56345 -1292 4 8.12483 9.46261 11.5696 0.628604 12.1613 -30.4224 -1293 6 15.3459 8.71493 30.7579 -11.6347 7.91644 6.32427 -1294 4 15.6589 9.0755 29.9373 15.0271 -3.29406 -15.5675 -1295 4 14.5238 9.21191 30.8811 4.80809 -7.40019 11.405 -1296 6 11.0133 17.2839 37.5617 38.0352 -12.2544 -11.7999 -1297 4 10.7898 18.2056 37.405 -17.5453 -0.0751596 7.29682 -1298 4 10.2607 16.7791 37.8546 -17.0302 3.42722 4.74802 -1299 6 42.1004 25.1498 20.3879 -5.861 18.5914 -24.6259 -1300 4 41.6093 25.7579 19.7998 14.6917 -4.46771 2.10695 -1301 4 41.6207 25.2703 21.1911 -4.19275 -5.86855 25.2901 -1302 6 25.8665 4.70671 33.8486 1.7241 -2.25531 12.4518 -1303 4 25.7694 4.46132 32.9448 -0.891619 -14.6084 -22.569 -1304 4 25.7648 5.65611 33.7952 0.475958 14.7418 11.4125 -1305 6 28.7412 10.81 24.3536 52.8166 -39.1996 0.778281 -1306 4 29.1275 10.6396 25.241 -21.7381 14.0631 -10.6288 -1307 4 29.4032 10.2753 23.8346 -27.1554 16.6107 -4.2243 -1308 6 5.01189 41.8147 11.1021 -10.1881 -24.042 21.7575 -1309 4 5.95007 41.5814 10.9281 -9.39093 5.64723 11.7156 -1310 4 4.65803 41.218 11.8386 16.8172 15.7397 -32.6044 -1311 6 51.752 12.7769 30.1551 43.115 4.76279 10.9474 -1312 4 51.4305 13.1775 29.3474 0.253404 7.28674 -13.194 -1313 4 52.748 12.9494 30.1798 -32.3905 -5.4963 0.108494 -1314 6 7.60816 6.20909 6.53323 -10.2625 -22.9413 3.332 -1315 4 6.75131 6.36879 6.93991 1.04412 16.1391 1.16177 -1316 4 7.47061 5.28848 6.27373 8.51121 0.713964 -9.51027 -1317 6 14.6661 26.987 30.1548 0.873164 4.36141 0.355215 -1318 4 14.582 27.1099 31.1251 1.36022 -4.92112 -14.8153 -1319 4 15.2266 27.7026 29.8055 -8.21389 -0.931444 11.6021 -1320 6 15.3264 3.73283 21.1643 -10.33 -3.58504 -6.01241 -1321 4 14.8638 4.27764 21.8464 -0.83547 -19.2341 -16.6374 -1322 4 14.7237 3.15769 20.6119 12.9204 22.2517 21.9232 -1323 6 18.6273 30.44 6.46759 12.0392 -23.7352 17.6185 -1324 4 19.0475 29.6706 6.98693 -16.3462 35.3997 -15.3304 -1325 4 19.3457 31.0864 6.33287 -5.93154 -6.64461 4.30044 -1326 6 40.7697 1.30953 12.81 -7.42069 2.69181 -0.220133 -1327 4 39.8771 1.67487 12.9664 8.30469 -1.85755 -8.75546 -1328 4 41.0842 1.69163 11.9727 1.23155 -3.30642 0.910493 -1329 6 17.7383 20.7435 41.5913 -9.25323 7.68498 -13.188 -1330 4 16.7989 21.0745 41.5362 27.0903 -5.35562 -1.00027 -1331 4 18.2994 21.1605 40.9095 -9.45455 4.50919 10.4973 -1332 6 20.4558 2.13279 12.3403 -30.0447 18.1891 -47.0851 -1333 4 19.8108 1.39557 12.2573 15.3988 9.29294 19.6505 -1334 4 20.198 2.64755 11.5038 12.9177 -17.2886 33.121 -1335 6 9.85302 37.1833 18.074 6.71136 -14.9304 -23.7857 -1336 4 9.92221 37.5908 18.9423 10.0316 4.42551 4.50256 -1337 4 10.7455 37.1149 17.635 -18.8442 6.56171 18.5414 -1338 6 22.8282 7.40677 18.9114 -6.23678 0.804763 -35.7596 -1339 4 23.277 7.74075 18.0859 -11.7777 -2.90663 21.4919 -1340 4 21.8757 7.287 18.6972 16.9035 1.85128 0.334711 -1341 6 12.8573 6.85868 39.0594 6.78943 -21.4649 -19.4044 -1342 4 12.3495 7.63841 39.2092 -16.9303 20.8315 3.03628 -1343 4 13.4346 6.77393 39.8096 4.28484 1.06254 16.6435 -1344 6 10.1565 2.40612 23.2517 -6.6479 23.561 31.1588 -1345 4 10.4099 1.98923 22.4441 -4.01424 -6.38426 -29.0568 -1346 4 9.49005 3.10319 23.0571 9.63138 -11.2124 -3.87372 -1347 6 12.5542 20.2161 19.5705 -7.34833 3.07917 -34.9419 -1348 4 11.7057 19.8107 19.7825 -3.93433 -3.45282 3.31954 -1349 4 12.4683 20.3478 18.5882 13.2674 0.522362 30.6915 -1350 6 53.8557 6.35775 18.9347 50.5758 7.3162 -16.743 -1351 4 53.0168 6.07594 19.2456 -23.2698 -10.9568 16.0684 -1352 4 54.5479 6.04339 19.5529 -19.4302 5.44353 -5.27334 -1353 6 1.75058 4.00903 13.2441 23.5728 -28.6973 -20.2265 -1354 4 1.21884 4.54583 13.7916 -24.4496 15.7193 15.6535 -1355 4 1.39876 3.10072 13.3493 7.47096 11.1043 -1.96467 -1356 6 2.68902 16.4655 4.58797 17.5454 -16.7281 26.1549 -1357 4 3.46748 16.2798 5.17846 -23.6637 11.3752 -17.7986 -1358 4 3.0109 17.1109 3.97132 2.36318 9.59715 -15.9168 -1359 6 22.6274 7.40182 35.0529 -33.099 -8.93325 -69.8706 -1360 4 21.8922 7.07895 34.3703 46.348 20.1786 48.898 -1361 4 22.5995 6.76718 35.7474 -8.35572 -20.8537 22.0506 -1362 6 30.6396 27.885 19.9 19.0923 35.3411 -25.0547 -1363 4 31.1106 28.5954 19.3754 -18.5592 -24.8751 19.2783 -1364 4 29.9814 27.5098 19.295 5.17179 -8.35919 5.46264 -1365 6 18.3573 9.54392 6.2041 9.96047 7.12844 39.1223 -1366 4 18.327 9.09374 5.37857 3.10343 -12.6247 -24.8999 -1367 4 19.1177 9.18386 6.70986 -9.9052 0.872737 -11.1311 -1368 6 21.018 30.3894 30.8381 -12.2875 -2.46479 40.1773 -1369 4 21.7266 31.0151 30.932 9.98027 8.24448 -8.07198 -1370 4 20.7269 30.28 31.7939 -0.642204 -5.24287 -40.3987 -1371 6 28.323 4.36597 15.0837 1.12527 39.8195 10.6489 -1372 4 27.8986 3.55092 15.2676 -12.4099 -32.2848 2.02696 -1373 4 29.0009 4.19376 14.4446 14.1396 -7.65384 -8.86362 -1374 6 12.7814 0.64254 16.5262 -20.2521 41.8336 -1.49998 -1375 4 13.0387 1.47629 17.0069 -1.64601 -27.4009 -13.133 -1376 4 12.0897 0.933072 15.8712 20.715 -4.46996 16.4219 -1377 6 27.5603 35.1844 8.24072 -26.8161 -1.20469 12.7263 -1378 4 28.0791 35.3455 7.47089 6.94403 2.76433 -19.537 -1379 4 26.8275 34.582 7.96906 18.9853 12.4469 9.56437 -1380 6 24.0704 5.17451 40.9985 43.9791 -14.9803 45.716 -1381 4 24.6298 5.96615 41.2045 -19.6374 -8.83437 -20.0494 -1382 4 23.3625 5.28724 40.4007 -22.1054 20.8081 -27.5224 -1383 6 16.8467 24.9145 28.3061 -32.8066 71.0274 -23.4158 -1384 4 15.8676 25.1613 28.454 39.6061 -31.4713 1.92714 -1385 4 17.0718 25.6559 27.6632 3.37355 -28.1253 20.4487 -1386 6 20.8411 12.7971 17.0095 43.3655 -24.1139 -5.17775 -1387 4 20.9692 13.6698 17.4217 0.0861137 -1.96629 -7.53612 -1388 4 21.7712 12.4167 16.7645 -47.1299 18.5523 16.3808 -1389 6 35.7683 23.0344 30.9263 1.08866 -13.108 5.55839 -1390 4 34.803 23.1301 30.928 3.64223 -3.31893 2.04139 -1391 4 35.9803 22.5404 31.7512 0.26244 15.2618 -11.5602 -1392 6 36.3065 21.404 25.8788 21.1988 16.3215 -11.4752 -1393 4 35.3711 21.2912 25.8279 -29.04 -8.19979 -7.71966 -1394 4 36.6742 20.6179 26.2596 7.44281 -15.7003 9.85929 -1395 6 13.4865 6.74911 5.29345 -32.6693 78.3701 45.7352 -1396 4 13.9616 6.05619 4.98306 41.5093 -80.328 -47.9816 -1397 4 12.7805 7.00791 4.71674 -14.9335 -5.37764 -13.3979 -1398 6 20.8104 20.4092 13.7653 1.99296 11.0688 -14.7475 -1399 4 21.268 20.4545 14.5989 11.9976 -3.76106 7.6647 -1400 4 19.8959 20.3184 13.9984 -15.4264 -4.27358 -1.02469 -1401 6 20.3637 29.125 1.38742 -7.39452 3.20569 15.6829 -1402 4 20.6257 29.8678 1.97015 -13.6171 -7.9879 -3.97808 -1403 4 19.4728 28.7955 1.69287 22.5847 10.4694 -9.78123 -1404 6 50.8792 13.1212 37.2655 -4.22961 23.9091 37.9372 -1405 4 51.3893 12.5589 37.8771 -2.47029 4.54984 -9.0483 -1406 4 50.5869 13.8674 37.8656 5.03029 -21.5284 -25.2034 -1407 6 33.9282 34.1694 20.494 -12.758 16.9363 4.62304 -1408 4 33.9505 34.3661 19.5368 -1.52487 0.481952 13.5649 -1409 4 33.2327 34.7631 20.901 14.0918 -19.53 -17.3949 -1410 6 26.2111 28.0581 27.5584 -15.6012 -12.4051 -9.62147 -1411 4 26.6887 28.3319 28.3498 -5.67664 4.83839 -0.885474 -1412 4 25.2376 28.0657 27.7416 20.5709 -1.16679 -1.23567 -1413 6 7.682 21.3042 4.28531 -31.6563 9.11884 52.3302 -1414 4 8.36407 20.9023 3.81015 41.1991 -18.6864 -33.8238 -1415 4 7.19271 21.9105 3.74865 -6.01459 10.7978 -19.2095 -1416 6 22.0049 15.1615 5.91526 -5.59087 32.8095 7.59658 -1417 4 22.5291 15.4011 5.14076 -1.79158 -8.25489 -6.60562 -1418 4 21.8369 14.2416 6.04435 2.97447 -25.4321 -3.26552 -1419 6 21.7136 24.0096 3.8157 22.5859 -13.9702 -11.1371 -1420 4 22.6792 24.1846 3.95073 -20.2229 4.30251 2.28349 -1421 4 21.6957 23.2604 3.18041 -1.04284 4.75891 13.5064 -1422 6 11.5672 23.7812 12.5534 10.6653 17.5289 -0.525849 -1423 4 11.8567 24.7317 12.4283 -11.704 -31.033 2.93832 -1424 4 11.2483 23.6794 13.4494 -5.02459 5.94744 7.15157 -1425 6 32.3679 18.058 29.8144 -2.59991 12.5874 27.6023 -1426 4 33.2958 17.8537 29.9681 1.40206 -2.08885 -2.88861 -1427 4 32.1708 17.8352 28.9168 3.64727 -16.5589 -23.8097 -1428 6 9.27501 12.3901 30.3257 8.89695 -9.73537 -4.18026 -1429 4 8.97738 13.0169 30.9954 -4.04452 2.00113 -0.0309771 -1430 4 10.1278 12.0418 30.6776 -19.7256 9.24572 -11.0885 -1431 6 40.1671 25.9203 9.1352 -31.1658 -6.55029 4.71016 -1432 4 40.7952 25.2818 9.45931 8.36253 -10.0667 -0.250848 -1433 4 40.6474 26.7215 9.01492 17.3912 21.2934 -6.4579 -1434 6 43.1616 32.3487 37.3267 7.45809 -19.2286 11.3512 -1435 4 42.8399 32.8446 36.5586 -11.2032 -5.45956 10.184 -1436 4 42.4733 31.7245 37.6799 8.3011 17.0164 -20.2151 -1437 6 44.0911 6.28198 31.259 8.64406 -6.47735 -33.2401 -1438 4 43.4563 6.84482 31.6606 -21.1773 24.4303 10.8162 -1439 4 44.5952 5.92873 31.9644 15.9286 -14.2375 24.3689 -1440 6 10.2063 18.8787 19.6978 14.6089 -0.63771 -2.74842 -1441 4 10.128 18.3979 20.5267 6.04825 -4.13467 -1.20166 -1442 4 9.36891 19.3219 19.635 -15.0357 8.38504 -1.1225 -1443 6 7.0561 15.5922 15.0299 -16.4573 19.9198 -23.3889 -1444 4 7.18612 15.4783 14.0721 1.05096 2.95086 4.94392 -1445 4 7.41457 14.833 15.4354 13.8635 -34.6267 13.25 -1446 6 24.544 3.4899 27.8655 -14.5565 -8.97091 -7.81951 -1447 4 23.6823 3.28725 28.2588 1.61952 11.0081 14.175 -1448 4 24.3729 3.16547 26.9791 10.0044 -2.74415 -7.35546 -1449 6 54.4109 31.8087 9.71194 -6.99911 23.6955 33.3298 -1450 4 53.8413 31.5567 9.00593 -8.22136 -4.9258 -26.1741 -1451 4 54.0752 32.6964 9.97695 10.2913 -15.383 -7.59421 -1452 6 6.81072 17.0817 36.2069 -39.6649 -0.569341 -18.8672 -1453 4 5.9036 16.7161 36.0961 17.2423 3.35707 18.397 -1454 4 7.03883 17.1994 35.2786 19.8939 2.17194 6.76773 -1455 6 28.6373 7.46216 20.4204 -3.00228 3.72915 -26.9716 -1456 4 27.791 7.71165 20.8314 -1.23568 -3.59083 -7.19581 -1457 4 28.5788 7.67124 19.4449 -3.89686 1.20908 30.1283 -1458 6 17.0427 1.7136 8.36469 -7.39711 4.96373 -17.441 -1459 4 16.9511 0.79552 8.17539 8.34993 -30.6792 14.2707 -1460 4 16.7364 2.03503 7.50962 2.58977 23.9868 7.32556 -1461 6 19.1319 19.334 35.5748 25.2315 11.3156 3.71898 -1462 4 18.4163 18.7293 35.4559 -12.7574 -15.0058 -3.77114 -1463 4 19.9108 18.8059 35.8312 -7.49406 2.79856 2.97864 -1464 6 7.31044 31.3665 13.5876 -12.5896 -10.3186 -18.1643 -1465 4 6.86348 30.5057 13.838 5.41483 30.5465 -8.86898 -1466 4 6.71656 31.9291 13.023 7.05746 -22.9991 7.02109 -1467 6 16.6555 5.24573 12.8486 0.44122 -36.1931 20.2204 -1468 4 17.4189 5.79101 12.9112 23.6003 17.0932 2.01526 -1469 4 16.8511 4.45507 13.4194 -12.0332 11.5633 -21.5138 -1470 6 43.8917 12.7482 34.58 -33.2024 -13.6106 -1.45858 -1471 4 43.9807 13.5999 34.156 2.60816 15.5254 -0.13451 -1472 4 42.9242 12.5381 34.5161 22.3754 -3.96122 -2.5942 -1473 6 42.656 36.4522 28.5282 -7.17959 22.9727 1.13167 -1474 4 42.279 37.3416 28.6522 -7.55712 -15.8866 -0.526154 -1475 4 43.5285 36.675 28.2003 16.3904 -10.8581 0.329061 -1476 6 35.3704 15.0467 6.02622 35.7531 43.3754 17.6476 -1477 4 35.9258 15.8884 5.86958 -26.5611 -35.5954 0.991204 -1478 4 34.7923 14.9488 5.27074 -5.69332 -0.0870189 -10.0798 -1479 6 19.4034 5.85396 6.19026 -42.6676 -37.2433 -25.4755 -1480 4 18.4973 6.11578 6.46985 14.7962 -6.51198 7.73248 -1481 4 20.0178 6.47164 6.48735 29.6225 43.4574 23.1864 -1482 6 29.2636 38.16 6.98139 -51.0091 34.2659 0.167673 -1483 4 28.4794 38.0546 7.56687 16.6219 5.90534 -14.0005 -1484 4 29.8812 37.5458 7.29338 34.0617 -33.3732 10.6718 -1485 6 19.3639 26.1879 8.4772 -1.75021 -19.5484 18.4946 -1486 4 19.3765 25.7536 9.37133 0.505418 11.6152 -20.7618 -1487 4 20.132 25.8039 8.02679 -2.64689 1.58972 6.88257 -1488 6 4.91801 16.6546 6.12902 16.8332 -1.31437 8.04366 -1489 4 5.58152 17.3 5.84506 -6.45866 4.1219 -0.991793 -1490 4 5.39084 15.8022 6.09449 -7.75564 17.9483 -2.53018 -1491 6 6.07873 16.6931 28.0679 20.4204 4.35008 -35.2212 -1492 4 5.19925 16.4426 27.8453 -29.7482 -9.15572 9.47762 -1493 4 6.44387 16.7631 27.1426 -3.77999 2.92972 38.3228 -1494 6 21.7313 29.3584 22.0941 -19.989 26.599 40.0594 -1495 4 21.5191 30.3374 22.0902 3.30888 -28.6715 -0.0155919 -1496 4 21.2646 29.0087 22.9228 20.4195 8.84702 -28.341 -1497 6 24.487 0.545827 12.8459 24.5625 -19.0276 8.44191 -1498 4 24.0381 0.883409 12.0817 -9.22903 10.6064 -10.7293 -1499 4 24.0836 0.980384 13.5911 -6.14963 8.46579 8.44801 -1500 6 18.4109 28.2545 40.3162 -15.9129 36.5713 -32.2972 -1501 4 18.3366 27.7076 41.0573 0.952339 -31.6797 34.0712 -1502 4 19.1875 27.9677 39.8503 10.0284 -2.61836 -5.50219 -1503 6 10.3807 17.4604 21.8947 -1.20821 -16.3296 3.13877 -1504 4 9.80057 16.6779 21.8113 10.8468 3.86983 1.60142 -1505 4 10.0443 17.9356 22.6521 -9.33664 9.03137 6.2204 -1506 6 13.5404 13.3591 39.6327 12.5768 11.767 30.0264 -1507 4 13.9188 14.1992 39.2886 -9.97897 -11.5724 13.3172 -1508 4 13.5464 13.3749 40.6413 1.33606 5.90172 -38.0522 -1509 6 19.5508 26.0247 24.7387 -47.8665 -1.21537 -13.2845 -1510 4 19.6189 25.3328 24.097 -5.62542 -9.91951 -19.3965 -1511 4 20.3649 25.9852 25.1641 45.3739 3.88293 31.7071 -1512 6 8.93445 25.8823 20.0822 -10.4543 -29.9419 8.18251 -1513 4 8.35083 26.4773 20.5043 -33.2288 11.519 27.1484 -1514 4 9.504 26.5029 19.6962 43.6798 16.1155 -28.0388 -1515 6 13.4493 41.2138 30.5102 -4.84662 -36.1256 25.75 -1516 4 14.2597 41.094 31.0483 -5.58856 8.18726 -8.9115 -1517 4 12.8416 40.5025 30.8796 12.8197 27.661 -18.9522 -1518 6 21.1596 21.6794 11.1163 10.7366 20.8259 2.41134 -1519 4 20.9554 20.8709 10.6777 -10.2383 -24.5438 -10.817 -1520 4 21.2276 21.4421 12.046 -2.84377 -3.57945 5.82209 -1521 6 43.5643 10.3136 15.5616 17.5969 -21.741 5.94749 -1522 4 43.2379 9.48961 15.149 2.99942 14.1859 3.68588 -1523 4 42.9802 11.0242 15.3396 -21.8087 10.2132 -10.2755 -1524 6 23.5302 5.07333 12.3088 -23.5628 55.8128 -25.3063 -1525 4 23.4112 4.1923 12.0373 1.19089 -49.3933 -5.08619 -1526 4 23.0178 5.53904 11.5656 24.5614 -12.3881 30.382 -1527 6 9.28539 15.401 4.24759 1.63269 -5.62651 -9.8947 -1528 4 9.02922 16.1115 4.82738 -12.4128 14.4693 4.40189 -1529 4 9.90895 14.9318 4.78697 15.8319 -9.58935 3.85081 -1530 6 26.711 10.8797 17.566 5.43365 -10.3343 -26.0937 -1531 4 26.4818 11.0142 18.4585 -6.06422 3.32013 41.5711 -1532 4 26.8019 11.7518 17.1937 0.341074 3.88847 -5.26754 -1533 6 26.0592 23.5875 33.6794 25.1455 50.9154 21.2543 -1534 4 25.4682 24.0785 33.1024 -8.24785 -6.01089 -9.80751 -1535 4 26.6604 24.3213 34.0779 -26.6739 -38.162 -12.8336 -1536 6 7.57385 10.4949 28.9097 -14.7972 2.07126 0.456687 -1537 4 6.75277 10.5859 29.4011 -5.17598 -12.8295 -3.89358 -1538 4 8.06091 11.2035 29.3139 24.0536 5.38729 3.77373 -1539 6 16.4953 16.9073 24.6459 13.4535 22.6993 31.6086 -1540 4 15.9363 17.7011 24.6942 7.46422 -1.49957 -9.096 -1541 4 16.1467 16.4045 23.9375 -12.5815 -17.1437 -28.632 -1542 6 12.5505 12.7927 0.441559 26.7797 -18.4986 61.4448 -1543 4 12.8902 12.7839 1.42408 -16.6807 15.1369 -51.7767 -1544 4 12.972 11.9767 0.117581 -17.3776 3.59908 -10.4186 -1545 6 6.80454 2.46926 9.04378 10.3033 -16.1572 19.5551 -1546 4 7.05376 2.92505 9.85651 -1.04006 9.78535 -3.84035 -1547 4 7.36555 1.67892 9.06596 -6.07141 -1.3767 -9.09165 -1548 6 28.8788 11.8454 12.005 47.3119 33.3239 7.75537 -1549 4 28.2175 12.4307 11.6211 -4.89696 7.77957 0.00959457 -1550 4 29.7805 12.2922 11.8721 -37.0304 -14.6121 1.30522 -1551 6 44.6756 32.5924 29.7091 -46.8228 -4.47104 18.0754 -1552 4 43.7214 32.9254 29.5641 42.8383 -8.78111 -1.84094 -1553 4 44.558 31.8742 30.3802 4.31467 20.1075 -17.1439 -1554 6 28.6099 15.1189 32.288 -8.09168 -64.7739 -6.10589 -1555 4 29.0591 15.887 31.9855 13.2175 18.1439 -15.8441 -1556 4 29.0109 14.3064 31.825 -10.272 37.9041 18.9788 -1557 6 1.13952 22.1955 33.6303 -59.4889 25.247 28.7943 -1558 4 0.675447 22.8098 33.0333 5.4615 -9.68619 7.91413 -1559 4 1.8611 21.9185 33.1521 52.5767 -22.4691 -40.0321 -1560 6 17.4529 16.8222 9.92046 -20.0761 -24.0842 48.1247 -1561 4 17.9341 17.1517 9.19999 21.5054 13.464 -32.8219 -1562 4 17.9802 16.1035 10.3295 -2.40424 8.44812 -14.2536 -1563 6 18.74 29.8021 14.3918 16.1488 4.65404 69.9188 -1564 4 19.5966 29.6355 14.8679 -24.5899 1.22938 -11.6521 -1565 4 18.9027 29.6655 13.4911 13.4763 -5.12933 -46.2854 -1566 6 39.4106 6.51176 13.0171 8.18439 9.54271 -9.98348 -1567 4 39.7968 7.3217 12.6105 -7.82756 -18.4389 5.68309 -1568 4 39.8965 5.76959 12.6221 -1.11983 7.69721 6.02388 -1569 6 54.1122 38.2735 14.316 -26.3921 15.7841 23.5556 -1570 4 53.5092 38.7211 14.9446 14.1224 -15.8084 0.476194 -1571 4 53.7657 38.6747 13.5269 5.67525 0.359642 -25.5906 -1572 6 7.51656 32.0218 20.9281 34.7748 10.0158 34.1931 -1573 4 7.08362 31.9253 20.1193 -22.6959 2.07513 -43.8223 -1574 4 7.03544 31.4175 21.4603 -12.2713 -14.4046 24.4342 -1575 6 26.9722 15.5137 13.836 8.2831 -9.07996 -12.1546 -1576 4 27.2905 14.6773 14.2204 -10.3825 7.39938 7.42218 -1577 4 26.0228 15.629 13.9568 -6.27371 -3.74993 11.5294 -1578 6 18.3731 16.4369 32.1258 -5.47484 6.15837 -16.1574 -1579 4 18.1737 16.7054 31.2071 -0.945967 -8.38127 9.44724 -1580 4 19.0036 17.0959 32.4159 12.6478 4.85619 3.13766 -1581 6 52.4904 31.6749 23.2282 -45.8236 3.94874 65.5164 -1582 4 52.5054 32.2301 24.055 -6.11863 -14.7847 -21.5508 -1583 4 53.2278 31.9578 22.7624 44.676 11.2926 -39.5338 -1584 6 2.17063 9.69676 28.2025 -10.599 22.0242 17.0864 -1585 4 2.41083 10.574 27.888 12.6445 -0.15763 -12.1006 -1586 4 1.36653 9.91172 28.7063 1.66945 -10.1846 4.32482 -1587 6 32.9295 0.084333 22.579 -26.8721 -17.4052 -13.8633 -1588 4 33.2309 41.109 22.2818 0.690852 17.8844 8.89147 -1589 4 33.6446 0.598803 22.932 23.7791 -0.031599 0.0852179 -1590 6 20.7171 41.5453 38.643 51.9522 19.855 -62.1487 -1591 4 20.0643 41.0408 39.0691 -29.2365 -22.9372 13.5286 -1592 4 20.9788 41.0468 37.7869 -12.0924 18.2625 49.3819 -1593 6 43.2965 24.3242 12.1559 29.4143 27.7167 -28.3716 -1594 4 43.2964 25.2918 12.2975 -10.3211 -14.9579 7.88207 -1595 4 44.0244 24.2792 11.4826 -12.2932 -11.2644 22.4039 -1596 6 22.0333 36.2992 11.8143 -17.8744 11.1706 -5.23693 -1597 4 21.6038 36.9407 11.2131 12.0614 -9.84488 11.7859 -1598 4 22.8639 36.0559 11.3996 4.49067 -2.6397 -1.6843 -1599 6 50.7446 20.5307 30.3299 -19.4296 24.1009 0.394401 -1600 4 50.3769 20.0585 31.0978 -4.60399 -0.499453 -6.82258 -1601 4 50.1204 21.2977 30.1594 19.9431 -26.9935 4.34337 -1602 6 20.8379 3.84934 18.1872 -10.63 2.24574 17.9634 -1603 4 21.6372 4.15439 17.7675 6.81748 4.13844 -2.44268 -1604 4 20.7537 4.31685 19.0447 1.53322 -4.30004 -12.0579 -1605 6 4.001 20.6421 6.99361 -18.7611 -9.71733 3.72301 -1606 4 3.09723 20.6004 6.53941 30.5715 -8.65918 22.3858 -1607 4 4.00786 20.2035 7.89591 -15.2068 14.2544 -28.772 -1608 6 11.948 15.4413 41.4409 9.86263 -45.3449 -5.39948 -1609 4 11.9713 14.4541 41.6361 -2.32711 35.624 3.02695 -1610 4 12.4708 15.4889 40.6181 -5.28805 11.0492 6.42 -1611 6 3.00764 18.5435 38.9252 6.90717 -29.584 40.0663 -1612 4 3.56523 17.7255 38.8717 -9.75827 16.9893 -1.25399 -1613 4 2.92934 18.9138 38.0721 -1.66709 15.3109 -35.9518 -1614 6 8.5978 38.8858 11.3072 48.4025 32.5603 4.46589 -1615 4 9.44036 39.0024 10.7943 -20.5341 -1.07382 9.55064 -1616 4 8.19448 38.1327 10.9484 -22.3544 -46.6733 -17.9601 -1617 6 12.9691 33.9778 38.4933 34.8069 -13.3685 -21.4899 -1618 4 12.6573 33.2385 37.9471 -9.06758 1.22663 10.2849 -1619 4 13.9307 33.983 38.2659 -20.4066 10.3952 14.8996 -1620 6 4.69069 11.9902 6.04709 5.57568 0.955193 2.63183 -1621 4 3.83092 11.6207 5.79405 1.19943 -2.71585 -3.65246 -1622 4 5.36696 11.7708 5.36999 -19.9658 -4.94035 2.87891 -1623 6 10.8381 15.9154 25.2196 -36.4648 2.02786 -4.38258 -1624 4 11.7191 16.2167 25.3262 31.8449 11.9168 5.4517 -1625 4 10.3518 16.6682 24.8476 5.65772 -8.76316 -0.529027 -1626 6 20.7604 3.23767 6.55488 4.15603 28.9608 0.670607 -1627 4 20.2106 2.56517 6.18958 -7.79877 -24.0058 -5.45951 -1628 4 20.2434 4.04703 6.45055 -2.36445 1.41903 2.77062 -1629 6 47.6381 39.1588 31.2153 -11.506 28.7103 -40.9212 -1630 4 46.7125 39.0803 30.8864 16.1685 3.01672 12.9065 -1631 4 48.0161 39.883 30.6238 -10.851 -36.2784 24.6994 -1632 6 8.33868 27.7571 27.6932 -33.938 3.65348 13.4266 -1633 4 7.90796 26.9962 28.1436 6.90464 18.5991 -0.450451 -1634 4 9.05762 27.3551 27.2376 19.8804 -10.068 -12.1598 -1635 6 33.245 40.3099 33.4253 18.3517 22.2199 -28.9554 -1636 4 32.5937 41.0038 33.2194 0.94932 -12.4457 9.89811 -1637 4 33.9479 40.492 32.7526 -7.59275 -9.33057 17.0692 -1638 6 24.5058 34.6327 27.2588 -1.70215 14.4876 -27.3243 -1639 4 24.8356 35.5409 27.0166 -5.53884 -24.0927 13.0812 -1640 4 24.1351 34.315 26.3934 7.47117 3.95694 29.9195 -1641 6 13.3256 36.76 35.7403 23.371 22.3884 -21.319 -1642 4 14.292 36.6204 35.8687 -19.0607 -2.42845 14.454 -1643 4 12.8134 36.0651 36.1242 -8.79549 -23.1532 9.33092 -1644 6 34.0568 20.1616 33.2139 18.2744 1.49148 -3.34215 -1645 4 34.901 20.3965 32.7524 -27.9907 10.0382 9.43414 -1646 4 33.5726 20.9405 33.5892 13.555 -8.0917 -8.63642 -1647 6 22.8329 33.5616 31.6214 -12.6844 15.5573 -21.5595 -1648 4 23.5755 34.1858 31.5969 1.53708 -3.14405 -0.637663 -1649 4 23.0292 32.8658 32.2325 13.4469 -12.4025 17.113 -1650 6 23.7434 2.42786 19.8498 9.49596 22.5629 12.9133 -1651 4 24.532 1.90722 19.7117 15.1933 -8.07802 -2.32773 -1652 4 23.0629 1.99408 19.3682 -23.4605 -15.8437 -14.4607 -1653 6 10.59 1.63974 20.5169 -0.95575 -6.83071 6.14558 -1654 4 9.98705 1.03236 20.0473 7.71399 2.84727 3.14747 -1655 4 10.6246 2.47233 20.0276 -8.35822 1.7372 -3.87231 -1656 6 6.50082 24.8628 7.81243 5.63459 3.09475 -4.38693 -1657 4 7.40706 24.9537 7.44087 -14.825 -10.0154 1.3351 -1658 4 6.01351 24.1359 7.38457 10.3118 5.93376 -6.27471 -1659 6 54.7907 32.5298 25.4601 2.42441 14.1538 -12.299 -1660 4 54.0693 33.194 25.3949 12.697 -15.3913 -0.923548 -1661 4 0.387469 32.6052 24.6546 -22.4501 -0.197402 25.3904 -1662 6 6.24565 20.1804 28.9699 -20.0835 16.2671 13.5362 -1663 4 5.37616 20.2206 28.5173 17.3942 -4.89439 1.50138 -1664 4 6.85708 19.7029 28.4106 5.94408 -11.9876 -6.03836 -1665 6 50.061 21.6087 11.3404 -11.515 44.0552 -42.0488 -1666 4 50.9725 21.751 11.0493 2.56545 -3.3262 -1.97817 -1667 4 50.0662 20.9568 11.9903 8.13397 -42.2403 36.0281 -1668 6 43.4741 33.5215 19.648 39.1267 -7.16957 -40.9914 -1669 4 43.8052 33.5504 20.5247 -1.27694 2.64583 28.8889 -1670 4 42.5461 33.5822 19.6063 -36.855 5.29583 12.3512 -1671 6 30.8225 7.19458 41.0729 -33.0718 18.8928 10.1641 -1672 4 30.0173 7.64992 40.6345 32.3343 -18.9847 22.962 -1673 4 30.7853 7.47469 0.131591 -1.52838 -8.42988 -38.7943 -1674 6 12.1264 25.8478 11.0965 -41.5825 -1.76886 -24.0951 -1675 4 11.2804 25.9828 10.5746 22.2453 -8.09118 27.7312 -1676 4 12.6111 26.6214 10.8799 25.9351 22.819 -1.42381 -1677 6 47.8207 5.82713 17.7363 28.7614 -16.7343 -8.46055 -1678 4 48.0335 5.15295 17.0353 -2.74159 24.5551 13.4979 -1679 4 48.6986 6.12754 18.0988 -19.3132 -4.26463 -8.98138 -1680 6 35.1697 12.9074 16.5814 -26.6969 23.1645 14.7724 -1681 4 35.331 12.9801 17.5341 9.94288 -5.95548 -5.31324 -1682 4 34.5116 13.6489 16.4838 18.7069 -22.8028 -11.189 -1683 6 10.4746 10.6344 33.9856 -30.1195 -20.4446 -6.31426 -1684 4 10.7944 11.3866 34.5009 -4.55531 -6.56386 0.452866 -1685 4 9.59186 10.377 34.349 25.6427 10.4215 -3.60637 -1686 6 9.86976 7.46809 9.66723 13.2706 -15.2427 -11.6817 -1687 4 9.07254 8.00079 9.6953 0.322066 10.4083 -1.78771 -1688 4 10.1027 7.29929 8.72005 -15.6005 8.2826 19.6359 -1689 6 11.1498 9.5629 29.1446 -4.60031 -6.3451 3.75047 -1690 4 10.6862 9.26798 29.9509 5.10767 2.07156 -10.4371 -1691 4 11.3249 8.76682 28.6116 2.75639 0.845127 6.4689 -1692 6 46.3982 12.7571 37.8973 13.0728 8.65129 -14.0384 -1693 4 46.6651 13.0033 36.9771 -6.5436 -6.98702 17.4091 -1694 4 46.8422 13.384 38.4935 -4.33131 -5.25976 0.421567 -1695 6 4.7745 19.0249 15.9997 -22.3762 2.96494 22.3523 -1696 4 4.16029 19.0173 16.7572 4.82074 7.85299 -8.34635 -1697 4 5.51792 18.5695 16.4006 17.242 -3.98645 -13.636 -1698 6 50.2756 39.8187 19.3535 -48.7732 -19.7782 -8.19609 -1699 4 50.1357 39.0812 19.9713 14.3147 6.83039 4.1366 -1700 4 49.4547 39.7468 18.7938 35.5854 8.27631 5.22634 -1701 6 3.57022 23.2982 26.3116 -7.21736 12.7853 -4.33091 -1702 4 3.04677 23.327 25.4841 2.15403 -9.28995 15.8001 -1703 4 3.1589 23.9918 26.8774 3.27351 -16.4313 -7.87876 -1704 6 43.3323 18.2357 20.5099 -9.76971 -1.121 -6.56922 -1705 4 42.7632 18.9863 20.7177 2.34101 2.93749 0.115163 -1706 4 43.9096 18.122 21.2711 1.48233 -4.92166 7.17918 -1707 6 14.4939 41.5272 19.7194 7.33174 -3.95938 -8.98841 -1708 4 13.9791 41.768 20.4704 -25.804 7.49044 14.4407 -1709 4 15.35 41.4773 20.1189 24.9681 -5.23262 -6.74673 -1710 6 29.2751 29.8624 26.915 55.5011 14.3278 -64.7852 -1711 4 29.462 29.6739 25.9095 -28.0317 9.76644 54.5148 -1712 4 30.1137 30.3565 27.1616 -29.5885 -20.0698 8.89328 -1713 6 6.32585 26.1455 11.5441 3.18215 15.5722 27.8672 -1714 4 6.22913 25.7559 12.4173 -5.87839 -9.43723 6.04013 -1715 4 6.88652 26.9071 11.7431 3.72153 0.148286 -16.8953 -1716 6 27.6581 9.23325 15.2376 24.6795 20.4415 1.81178 -1717 4 28.3906 9.86787 14.9946 -20.7277 -22.2866 6.02651 -1718 4 27.7257 8.49599 14.6233 3.42822 -3.8556 -2.27597 -1719 6 29.7826 38.0629 17.0951 -21.7625 -1.10982 -31.3954 -1720 4 29.5447 37.2807 16.5438 11.5646 7.7876 16.1146 -1721 4 29.1666 38.7512 16.7768 9.10566 -6.75007 12.2127 -1722 6 52.2237 28.7307 4.26632 40.7154 12.5569 -19.536 -1723 4 53.094 28.6942 3.75761 -25.982 6.02481 23.1744 -1724 4 51.8384 27.8718 4.17524 -3.40498 -27.0863 -4.04919 -1725 6 17.1651 16.6761 6.10093 10.0081 29.999 -15.4838 -1726 4 17.0645 17.5224 6.60658 -3.46995 -23.4179 -4.25622 -1727 4 16.9429 15.9406 6.65512 -3.52922 -13.7209 19.1007 -1728 6 36.6584 7.55275 33.426 1.51046 -27.4434 34.6673 -1729 4 36.0562 7.00422 33.9909 9.38132 12.247 -13.9906 -1730 4 36.0891 7.78594 32.7139 -15.8398 12.8789 -25.2624 -1731 6 26.1693 3.13272 9.58463 26.4836 36.1065 -53.3475 -1732 4 26.5189 3.61335 10.3026 12.8321 10.8542 33.1136 -1733 4 25.6805 2.43597 9.90138 -37.6231 -51.1462 30.1839 -1734 6 1.19232 17.1076 33.1734 0.722887 26.1228 -9.87087 -1735 4 1.0219 17.7977 32.4875 3.44775 -13.3597 11.6369 -1736 4 0.89275 17.4757 34.0242 -0.842403 -4.58413 -3.86686 -1737 6 29.175 10.1805 5.37687 2.48705 -7.47299 -1.58449 -1738 4 28.5307 10.3443 6.0806 2.54341 -1.49901 -0.102048 -1739 4 29.6529 9.35261 5.56356 -13.9845 3.47491 -0.693848 -1740 6 9.21964 21.135 0.193729 30.6013 -8.57211 -16.2038 -1741 4 9.93935 20.7152 41.5745 -5.21063 7.9265 20.924 -1742 4 8.4582 20.7874 41.6647 -18.4316 -1.36421 1.54976 -1743 6 7.41915 26.897 34.8578 6.273 24.0322 40.4596 -1744 4 7.07209 27.1094 35.7714 11.2799 -9.18849 -34.7736 -1745 4 6.87885 26.1925 34.5434 -18.5272 -22.724 -11.5995 -1746 6 18.6237 10.1563 3.02822 -55.9716 37.9013 1.68891 -1747 4 17.9823 9.44023 2.87563 14.9297 4.34306 1.98909 -1748 4 18.009 10.9755 3.18254 40.8652 -32.8317 -2.61569 -1749 6 13.1455 21.2337 25.2154 -14.3081 5.93545 -14.9534 -1750 4 12.8153 21.6822 24.4216 9.6722 -4.26313 4.93127 -1751 4 12.7862 20.3541 25.1726 -3.49479 -14.4912 -0.313259 -1752 6 4.91031 24.4198 40.532 -13.7809 -26.5024 -53.169 -1753 4 5.65778 24.4539 41.0894 26.3299 12.2697 26.6549 -1754 4 5.26856 23.9753 39.7091 -18.4358 16.5303 24.5031 -1755 6 54.7198 6.2862 9.93073 18.558 2.67796 -18.7732 -1756 4 54.1336 6.00192 10.611 -15.308 -5.80798 23.6242 -1757 4 0.005563 7.17106 10.1764 0.43073 7.36928 5.10877 -1758 6 51.7604 16.6436 19.3877 -20.3234 -7.55047 -14.8495 -1759 4 51.6779 16.1639 18.5383 1.1676 14.9854 4.84802 -1760 4 52.2077 17.4816 19.2574 16.3674 3.30585 -9.00164 -1761 6 38.6218 2.96001 13.0988 15.7387 3.67705 55.5859 -1762 4 38.6299 3.43096 13.9849 -4.06073 -12.9308 -23.724 -1763 4 38.2169 3.56793 12.5083 -12.8186 19.7945 -24.9943 -1764 6 19.4471 35.7007 9.61167 2.35324 -8.95281 6.35471 -1765 4 18.8335 36.2871 9.19379 -17.9936 2.63552 -14.7984 -1766 4 18.9495 35.3837 10.3842 8.56204 6.47345 -9.11173 -1767 6 46.9457 37.6212 25.7021 -15.6754 4.57489 10.5165 -1768 4 47.0239 38.0262 24.8354 11.6036 -0.197794 -10.4287 -1769 4 47.7281 37.1166 25.9279 8.14222 -0.129186 -6.11913 -1770 6 20.0249 17.2708 14.7582 9.34392 -2.11639 -6.02108 -1771 4 19.1723 17.4786 15.1706 12.7461 -0.873648 3.80655 -1772 4 20.7009 17.0069 15.4035 -13.3418 2.74043 0.572405 -1773 6 24.7358 29.2923 3.78206 18.5642 -33.4808 -47.1325 -1774 4 24.7422 28.3915 3.3709 -13.1038 11.8323 28.3161 -1775 4 25.3506 29.6775 3.14782 -2.77927 21.1078 10.4189 -1776 6 3.43141 8.92567 6.82668 25.8011 -1.75535 29.9445 -1777 4 3.08486 8.82716 7.75964 16.0017 4.22665 -30.6726 -1778 4 4.42441 9.10783 6.89545 -42.5611 -5.30748 1.54274 -1779 6 17.4891 30.59 19.7026 37.1524 -11.5388 -6.241 -1780 4 18.4343 30.3591 19.4199 -38.2372 10.1448 10.4771 -1781 4 16.9657 29.7875 19.5831 -4.14236 3.18225 -9.29444 -1782 6 13.2748 16.1833 39.0603 8.39615 -10.6604 2.01333 -1783 4 13.778 16.9491 39.3364 8.93523 3.59341 7.63718 -1784 4 12.5498 16.5465 38.5646 -17.693 7.52452 -10.3405 -1785 6 23.8419 27.9652 11.5971 -29.0622 15.8949 5.8355 -1786 4 23.0433 27.5239 11.9581 15.8216 -1.64981 -8.50246 -1787 4 23.6687 28.8945 11.8451 9.38175 -9.8305 -3.59643 -1788 6 14.4582 24.411 21.2251 -13.2323 27.0215 19.0701 -1789 4 13.9163 25.2229 21.3861 13.2503 -9.35589 -12.2275 -1790 4 14.348 23.9323 22.0593 -1.27999 -3.95586 -5.82862 -1791 6 46.6209 15.1404 22.2877 -21.0909 8.30909 34.5316 -1792 4 45.8336 14.7024 21.9608 7.3328 -3.88381 -14.3297 -1793 4 47.2246 15.4169 21.6106 10.5055 -5.27886 -22.0515 -1794 6 19.1453 29.7169 11.8746 -27.0123 -18.8736 -35.9167 -1795 4 18.7667 30.5363 11.5796 10.8323 29.6783 4.39578 -1796 4 18.5214 29.1838 11.3275 23.3568 -13.7991 20.8336 -1797 6 36.9132 18.8016 27.615 -17.0652 -23.8487 30.8874 -1798 4 36.4034 18.4868 26.8464 6.26881 1.65463 6.80847 -1799 4 36.6041 18.1666 28.3506 10.215 31.7365 -33.4968 -1800 6 35.8839 17.5137 25.5036 -5.81764 30.7264 -16.7466 -1801 4 36.5665 17.9094 24.9 -10.7703 -22.5287 9.19997 -1802 4 35.9135 16.5474 25.44 8.68204 5.15754 -2.43364 -1803 6 8.04468 41.8981 31.5366 26.4021 9.77217 -3.38911 -1804 4 8.66886 41.284 31.9946 -24.4733 15.0027 -13.0466 -1805 4 8.60227 0.704634 31.1522 -11.4596 -14.2431 6.13083 -1806 6 31.7024 34.8356 17.9299 26.5575 -27.0845 -4.88708 -1807 4 32.6196 34.4986 17.7931 -22.3662 0.836155 -3.84042 -1808 4 31.9071 35.6664 18.3392 -5.09232 26.8034 6.09861 -1809 6 22.0993 41.0535 5.13739 10.0927 40.3608 -89.4928 -1810 4 22.1435 40.6782 5.94278 2.96748 -46.7441 88.004 -1811 4 22.8097 40.6452 4.60918 -8.49191 2.25551 6.5005 -1812 6 11.6188 5.17183 29.5438 -37.4391 -17.3681 45.4318 -1813 4 12.0782 4.3477 29.7115 12.4576 1.56532 -11.0695 -1814 4 10.8376 5.06958 30.1835 21.3256 14.0691 -33.8944 -1815 6 13.0142 9.45267 21.0738 -17.3871 -39.5803 -33.4019 -1816 4 13.648 9.91302 21.5572 37.1542 33.3127 26.6408 -1817 4 13.4951 8.71823 20.6397 -14.9934 11.5246 2.17133 -1818 6 12.4259 4.16416 0.171584 25.5917 58.0572 -18.9009 -1819 4 12.7038 3.75631 0.988868 -0.121161 -3.62646 8.37405 -1820 4 12.9914 5.02921 0.073462 -27.1162 -49.1387 2.0493 -1821 6 45.1548 14.6294 28.1056 43.5869 -15.7342 -2.79686 -1822 4 45.3799 14.9442 27.2254 -14.4652 2.82802 -6.08545 -1823 4 46.001 14.1543 28.294 -26.1128 6.03561 5.66217 -1824 6 52.5819 19.2522 0.880939 -13.6546 -24.4625 3.21793 -1825 4 52.4967 19.3157 41.8353 6.16951 -6.72877 -2.3034 -1826 4 52.7342 20.1258 1.1855 8.55196 28.2584 6.16427 -1827 6 0.17636 18.5769 30.5692 -13.5341 -21.3209 11.3545 -1828 4 0.97347 18.6538 30.0344 3.16555 8.74201 -0.550561 -1829 4 54.7381 19.4288 30.6755 1.51483 11.9419 -1.05075 -1830 6 17.6474 28.1849 1.96582 -3.95698 7.79984 2.09024 -1831 4 17.0036 28.8884 1.72628 7.01161 -11.1903 7.18073 -1832 4 17.5665 28.0879 2.93205 1.48476 5.36119 -8.9874 -1833 6 22.5179 30.1562 5.01973 -0.557011 13.5756 -11.2394 -1834 4 23.053 30.1464 4.21842 7.71181 1.56353 5.86697 -1835 4 22.1417 29.2826 4.9966 -11.5089 -8.75783 6.0437 -1836 6 11.3992 8.80614 17.6425 18.8049 17.2909 -5.92301 -1837 4 12.0044 8.1818 18.0403 -8.94801 -14.7479 17.6102 -1838 4 12.0653 9.44286 17.3244 -18.8797 1.15675 -4.46111 -1839 6 32.2825 3.5901 26.8335 38.6865 42.7422 0.354813 -1840 4 31.9744 3.38447 25.9652 -16.937 -9.17442 -22.5821 -1841 4 32.8531 4.41036 26.697 -18.7333 -32.0278 -1.10411 -1842 6 26.8283 37.1448 15.664 9.9544 44.9512 -6.81835 -1843 4 26.832 37.6522 16.5019 -4.80771 -22.2764 -7.00776 -1844 4 26.708 36.2069 15.7377 -4.77442 -21.1488 11.5765 -1845 6 22.9466 3.40402 22.281 26.551 -3.46013 -1.27592 -1846 4 23.3626 3.00539 21.4748 -15.0613 6.75 14.6032 -1847 4 23.702 3.67884 22.8406 -14.5661 -4.86975 -12.1571 -1848 6 14.6187 28.2219 5.2011 12.2375 -1.31522 5.54773 -1849 4 14.146 28.1316 4.37141 -5.71124 1.87741 -8.30492 -1850 4 14.2863 29.0052 5.66137 -0.824291 -0.470469 -2.06805 -1851 6 20.2555 37.1856 16.5486 -24.9193 16.4856 21.7008 -1852 4 21.0596 37.4718 16.144 26.6499 6.5165 -11.4453 -1853 4 20.1477 37.8155 17.2956 -4.48599 -12.7862 -6.90992 -1854 6 17.9469 28.5629 23.8891 26.0841 -15.2841 -12.8531 -1855 4 18.7956 28.2639 23.4837 -20.5944 5.95667 14.8805 -1856 4 17.3322 27.8283 23.7208 -3.07308 9.52654 -1.59768 -1857 6 33.6454 24.2344 25.2281 6.08515 -19.3492 9.67379 -1858 4 33.7229 23.2583 25.1621 -7.7165 13.5894 -11.682 -1859 4 33.9838 24.3464 26.1231 0.527101 9.69022 -3.14208 -1860 6 9.99248 17.6305 2.22889 -2.94775 -31.1618 -12.577 -1861 4 10.7668 17.5307 1.6348 -7.17319 1.58445 12.7603 -1862 4 9.8062 16.7546 2.64219 6.61617 15.6433 -4.64734 -1863 6 24.3378 36.7975 8.92134 10.0949 -17.5556 18.6285 -1864 4 24.0798 37.5812 8.46711 -7.4438 24.0622 -5.98172 -1865 4 24.7733 37.0584 9.7453 -6.84359 -4.10885 -5.58351 -1866 6 14.3929 4.30304 27.7402 56.7365 -3.53996 19.7179 -1867 4 15.3546 4.44499 27.4586 -37.3153 -7.57895 7.00929 -1868 4 13.8272 4.37832 26.9899 -16.116 5.01688 -19.8092 -1869 6 13.2096 25.4586 35.3298 -3.87145 -6.51473 -10.8119 -1870 4 13.1476 25.2267 36.278 -1.83966 -3.78777 -13.8323 -1871 4 12.5545 24.9939 34.7684 5.09589 5.85633 19.2997 -1872 6 43.7315 33.1816 24.4051 17.2004 -9.02075 24.8986 -1873 4 44.3591 33.0681 25.1678 -20.1541 -6.26738 -17.3644 -1874 4 44.1096 33.9146 23.9227 -1.6352 8.32092 -8.69406 -1875 6 6.97009 30.4077 7.13769 23.121 1.43384 34.0809 -1876 4 6.71282 29.9591 7.9596 7.06976 3.62274 -2.26904 -1877 4 6.20421 30.2819 6.61977 -27.9511 -2.76807 -27.2062 -1878 6 44.437 39.4145 21.7835 -9.43682 11.6365 -18.5611 -1879 4 43.878 39.1032 21.0489 1.92512 -11.9494 17.5009 -1880 4 44.878 40.1639 21.3648 8.44417 -6.89071 6.17346 -1881 6 1.1648 16.4475 24.9778 -2.61131 5.39938 13.1681 -1882 4 1.07525 17.0286 24.1819 -7.88043 -13.0173 22.3573 -1883 4 0.434843 16.5677 25.6378 18.4556 1.9359 -28.7216 -1884 6 8.16988 33.8361 10.6637 16.6829 23.9256 47.7562 -1885 4 8.49559 33.5478 9.83195 -4.50358 -22.2449 -29.7436 -1886 4 7.35799 33.4028 10.9227 -18.4601 -13.1254 -8.86092 -1887 6 45.3716 15.8699 40.491 -6.36942 -3.03704 -2.15917 -1888 4 44.5133 15.7719 40.0601 4.63234 -6.98635 -0.416374 -1889 4 45.243 16.6248 41.0649 5.7116 1.92459 5.42472 -1890 6 38.7776 4.29245 15.9056 11.0795 0.30753 4.41463 -1891 4 39.6766 4.00679 16.0952 1.69097 -2.92337 -3.33067 -1892 4 38.5504 4.73291 16.7401 -7.14778 -2.92142 -9.36231 -1893 6 21.0846 9.20759 23.9691 5.60032 -0.18462 4.18544 -1894 4 20.9445 8.65571 23.1711 -3.69603 16.8592 7.46004 -1895 4 20.5672 10.0363 23.9442 1.93643 -14.5945 -11.3561 -1896 6 6.46938 36.1391 20.0069 4.0004 4.10087 4.13062 -1897 4 5.99357 35.3124 19.8297 -2.3473 7.0562 -2.30419 -1898 4 7.3052 35.893 20.4098 -0.600933 -5.92452 -3.30983 -1899 6 17.7588 23.4635 11.2444 16.528 -28.2646 53.7307 -1900 4 16.9432 23.8548 11.0264 -32.805 26.4079 -23.7501 -1901 4 17.621 23.3206 12.2167 9.32529 -0.814156 -28.2078 -1902 6 2.23938 39.2705 23.5372 32.4488 -19.3396 -21.3039 -1903 4 2.96143 39.1072 24.212 -19.8533 -4.03587 -26.9428 -1904 4 2.57592 39.0525 22.6024 -11.4643 11.6849 46.2914 -1905 6 21.7189 10.3135 3.08585 -2.90529 19.7604 61.578 -1906 4 21.843 10.1221 2.19424 -0.974385 -17.6276 -55.1642 -1907 4 20.7734 10.4085 3.28686 2.80557 -4.86174 -11.6796 -1908 6 13.3371 37.6485 26.8148 34.7445 -2.08205 -3.58175 -1909 4 12.7942 37.01 27.2655 -5.666 -15.7112 8.11946 -1910 4 14.1995 37.1812 26.5945 -31.1056 12.6209 6.4215 -1911 6 45.679 9.86525 8.82671 -1.22844 -5.97168 -0.0165319 -1912 4 45.3204 9.57969 7.98479 1.29945 7.51218 -9.52666 -1913 4 45.2548 9.27624 9.44517 -6.37871 -3.09075 9.62419 -1914 6 39.8117 32.343 29.5858 -3.04799 14.0722 -9.88422 -1915 4 39.6223 31.4471 29.2796 3.58631 -7.81261 7.71305 -1916 4 40.3439 32.3214 30.3816 0.770365 -10.1242 2.16071 -1917 6 39.1301 32.1592 8.96473 45.9624 -7.76569 -23.2306 -1918 4 39.6852 32.0596 8.1252 -31.4186 4.60772 35.1501 -1919 4 38.2007 32.2042 8.75798 -9.66602 0.778467 -8.76952 -1920 6 29.7501 11.3103 40.3404 42.6438 -12.6008 -10.1865 -1921 4 29.0692 10.6634 40.5326 -1.99158 -8.72077 -0.363163 -1922 4 30.6164 10.7842 40.3158 -34.6338 15.486 -0.0451708 -1923 6 24.8345 19.8801 29.8412 -7.59088 37.7695 16.0848 -1924 4 24.9026 19.0378 30.268 -1.65451 -21.4471 9.48031 -1925 4 24.5694 20.5293 30.547 8.64688 -23.6335 -15.2845 -1926 6 50.0799 29.4689 2.86832 11.3398 7.37373 -14.0975 -1927 4 50.7937 29.3382 3.51213 -5.95266 6.62042 -8.33887 -1928 4 50.5172 29.4209 1.98721 -16.9062 -3.16045 21.5768 -1929 6 26.3158 13.2487 37.9516 44.6834 6.62304 1.7852 -1930 4 27.2667 13.2121 37.7291 -19.4356 -10.4808 -19.3263 -1931 4 26.4654 13.336 38.8817 -25.2145 10.5198 25.1195 -1932 6 24.3285 13.817 16.1492 -2.87417 -29.0242 -9.8062 -1933 4 24.8278 14.0306 16.9324 2.95884 13.8503 11.1204 -1934 4 24.1796 14.5912 15.6032 1.91347 13.6823 2.96602 -1935 6 21.9624 25.0824 8.00452 15.4008 12.078 14.6814 -1936 4 22.598 25.7039 7.58094 -6.50256 -15.9793 3.04336 -1937 4 22.4506 24.6482 8.74092 -7.92214 9.81208 -17.5113 -1938 6 50.1646 25.295 29.0323 7.20414 -13.325 -13.2678 -1939 4 50.9752 25.188 28.522 -3.46618 -9.57224 -11.582 -1940 4 50.4808 25.9292 29.6536 -4.58067 20.151 23.6328 -1941 6 23.186 6.81871 7.63171 8.52809 43.4321 -4.70249 -1942 4 24.005 7.36604 7.81791 -26.2659 -19.6382 -4.15731 -1943 4 22.4749 7.49932 7.50679 12.9101 -23.886 0.0924589 -1944 6 6.93738 5.85096 20.8328 -1.25739 23.0019 -5.42089 -1945 4 7.49016 6.65136 20.6793 -8.05782 -22.0664 2.33926 -1946 4 6.43567 5.73489 20.0135 6.68134 -11.6114 -0.0369962 -1947 6 25.4027 39.7503 23.9523 -6.31967 32.2782 -31.5462 -1948 4 25.6215 38.8259 24.0292 3.86532 -10.8289 -5.32001 -1949 4 25.5293 40.0494 22.9984 1.78505 -20.5244 33.6821 -1950 6 10.8465 30.682 2.12076 -14.9417 -4.95607 29.3443 -1951 4 9.91334 30.8811 2.27771 3.65307 -4.25506 9.47201 -1952 4 11.0492 31.2188 1.38489 10.4343 12.2811 -36.8692 -1953 6 23.0846 40.5263 40.0577 -14.1833 12.856 -13.2149 -1954 4 23.7732 40.7716 39.4116 -4.4893 -4.99974 3.24897 -1955 4 22.2685 41.0049 39.7737 14.5189 -12.3092 -2.05606 -1956 6 29.2062 28.3669 37.5673 -46.9973 46.4688 -26.4511 -1957 4 28.2092 28.447 37.3765 47.4284 -5.55714 9.99444 -1958 4 29.3363 27.5265 37.9547 9.31284 -31.0764 15.334 -1959 6 1.86163 12.1711 18.0765 -5.91003 5.49035 -5.71632 -1960 4 2.55659 11.9166 18.6527 25.6221 -14.4574 8.12849 -1961 4 1.26079 12.5379 18.7153 -20.6967 6.08864 -3.03965 -1962 6 35.8475 14.1052 8.57203 -21.6385 -0.893463 -33.3774 -1963 4 35.1968 13.4152 8.63145 -9.00219 -13.9675 31.2536 -1964 4 35.5915 14.3843 7.67264 23.8052 12.2531 2.11843 -1965 6 9.47935 39.8135 37.5891 59.0759 6.31763 -30.1219 -1966 4 10.4266 39.6693 37.2666 -35.8633 -8.68454 26.4626 -1967 4 9.26489 40.5592 37.0217 -20.4655 -4.29881 5.22341 -1968 6 3.55142 30.3339 19.2713 -4.86381 -1.52132 15.3498 -1969 4 4.33638 30.9045 19.2209 2.57405 -7.87202 3.73908 -1970 4 3.61239 29.7873 20.0935 6.99099 14.0083 -17.3235 -1971 6 36.3358 32.3745 17.56 -88.747 -21.2483 -18.3477 -1972 4 37.1123 32.7301 17.855 71.5568 29.0637 22.2427 -1973 4 36.4955 31.7908 16.8209 7.92507 -6.87638 -5.35096 -1974 6 22.0663 24.5107 41.4102 10.2987 16.3962 12.7497 -1975 4 21.8202 25.2352 0.099599 7.35269 -2.74787 -1.24985 -1976 4 21.4331 24.5495 40.7007 -15.7672 -0.145359 -12.6123 -1977 6 45.7559 15.6146 11.6534 9.54961 -0.52573 -11.8143 -1978 4 46.6616 15.9476 11.7359 -2.85604 3.39399 3.95489 -1979 4 45.8337 14.6574 11.6049 5.18085 -12.4794 -2.56515 -1980 6 22.3677 20.3608 16.0248 -8.43349 0.762232 -3.33301 -1981 4 21.8453 20.4382 16.8206 -16.1556 -9.64869 10.2413 -1982 4 23.0114 21.0388 16.1556 20.3116 20.3082 3.24798 -1983 6 25.8272 25.7408 18.9039 -4.38174 23.1082 -8.64826 -1984 4 25.2526 26.4897 18.6396 10.1677 -11.9346 2.39614 -1985 4 25.327 25.3554 19.6213 -1.60311 -10.6753 3.35926 -1986 6 35.3217 34.2027 33.2895 -15.2368 -41.9721 4.95923 -1987 4 35.4982 35.1152 33.2737 3.10328 43.0158 -1.14622 -1988 4 34.4946 34.1251 33.8 0.780353 -3.85018 -10.6306 -1989 6 39.2773 17.1161 17.3873 -13.1248 -32.2738 -8.05101 -1990 4 39.9918 17.6798 17.5739 28.094 23.6652 8.23643 -1991 4 38.688 17.6273 16.829 -11.1713 3.07886 5.75329 -1992 6 0.390078 14.9382 21.7871 11.1367 4.76555 -0.935352 -1993 4 54.4387 14.8735 21.5807 -4.47162 2.48431 -1.07762 -1994 4 0.539841 14.2564 22.4568 -0.558284 -6.24417 -4.29591 -1995 6 15.9777 23.2264 17.7728 8.65625 13.1041 -6.34263 -1996 4 15.4566 22.9884 16.9791 5.52796 1.00784 5.82867 -1997 4 16.2806 24.159 17.6616 -10.6082 -13.1932 5.11686 -1998 6 5.23931 11.1231 17.5575 35.8701 -10.5445 17.9772 -1999 4 4.9182 10.2425 17.6538 -30.0926 -10.858 -8.95801 -2000 4 6.0864 10.9521 18.0214 -7.64643 27.0942 -5.06777 -2001 6 9.32885 36.7248 13.2722 18.9931 -22.2768 -8.23823 -2002 4 9.60165 35.7781 13.2295 -3.69965 14.6724 -0.704445 -2003 4 9.76236 37.1699 12.5317 -7.58045 -2.70049 0.515103 -2004 6 25.4778 33.5648 0.584885 -10.5355 67.2754 -12.4068 -2005 4 25.5984 34.5208 0.879361 -11.6997 -30.6233 -9.64051 -2006 4 26.086 33.1118 1.1181 20.4991 -31.2317 29.3626 -2007 6 17.3118 24.383 31.3319 -1.28664 6.54307 -2.76395 -2008 4 17.7194 25.1777 30.9449 -5.40799 -4.17061 0.343513 -2009 4 16.6541 24.6578 31.9842 -4.89885 3.77294 -0.581941 -2010 6 50.5608 32.7082 27.7934 4.54158 -2.94952 -18.7634 -2011 4 50.7453 32.9177 28.6973 0.494052 11.2961 18.8161 -2012 4 49.6536 32.9735 27.676 -15.0266 -0.0998574 -2.84245 -2013 6 2.26734 37.236 16.1173 -6.42813 -12.7591 -21.9136 -2014 4 3.23226 37.3187 16.1136 -7.03488 -2.64717 4.42174 -2015 4 1.90002 37.4962 16.9584 8.86323 8.39289 12.7736 -2016 6 25.781 33.1953 8.40059 -29.5389 -21.3471 9.61313 -2017 4 24.912 33.1588 8.86731 13.6407 4.32372 -10.5279 -2018 4 25.7521 32.4014 7.84509 3.14784 4.30114 -1.53431 -2019 6 24.7803 7.83271 25.42 33.5144 32.018 13.9598 -2020 4 25.5535 8.29724 25.0002 -28.4293 -10.6828 16.5011 -2021 4 24.3491 7.42211 24.7041 -24.9556 -17.4551 -27.4815 -2022 6 44.0168 27.3303 21.5604 -2.1935 -26.0293 -25.9567 -2023 4 43.1804 27.7287 21.7105 -15.5436 25.6402 11.6584 -2024 4 43.7182 26.5374 21.0766 16.4483 6.01939 6.04345 -2025 6 20.8314 32.075 6.72772 34.1297 -23.9008 -4.85338 -2026 4 21.613 31.4679 6.7544 -19.7741 14.5872 -14.4381 -2027 4 20.6476 32.1788 7.6576 -7.69651 14.1485 11.3249 -2028 6 0.619789 26.0994 3.99415 -10.3518 14.1264 10.767 -2029 4 0.887335 25.4928 3.30986 5.36048 -13.1936 -7.97543 -2030 4 1.24971 25.9998 4.71308 0.85353 -1.82089 -1.56654 -2031 6 23.69 0.227417 22.8544 35.0871 1.11343 17.3571 -2032 4 23.3906 1.11513 23.0752 -8.28129 -2.57498 -6.74336 -2033 4 24.6181 0.214091 23.2237 -29.0994 -2.98435 -11.3486 -2034 6 35.6339 26.9438 6.46453 10.8918 50.3879 3.14258 -2035 4 36.2586 27.0344 7.19591 -3.09793 -24.7425 -0.485193 -2036 4 35.6905 27.8753 6.10871 -13.1004 -35.3011 6.52721 -2037 6 50.1792 7.09321 18.6927 -10.3798 0.485236 0.91939 -2038 4 50.7755 7.39768 17.9917 2.23399 -7.26744 -1.07457 -2039 4 49.6856 7.89728 18.8977 2.66313 1.30029 -2.34319 -2040 6 12.4725 14.8259 12.1994 -11.4238 -12.6169 14.8051 -2041 4 11.6664 14.488 12.6556 18.5487 5.78377 -7.93059 -2042 4 12.1518 15.362 11.4889 -6.75978 6.85562 -13.2996 -2043 6 52.4644 22.357 36.3266 1.29806 9.96622 10.4358 -2044 4 51.6029 21.898 36.3064 11.3287 0.910024 -15.7837 -2045 4 53.0734 22.0059 35.6434 -17.6122 -2.36697 5.80151 -2046 6 41.7741 11.4843 39.1248 -4.39753 -8.31887 -97.8346 -2047 4 42.1028 11.6824 39.9378 27.3537 17.7413 77.2645 -2048 4 42.4804 11.7867 38.4877 -22.5072 -9.73773 16.9601 -2049 6 13.8016 22.5118 39.1095 -61.9889 -17.7515 -30.6487 -2050 4 12.8197 22.2903 39.2632 45.6803 12.2331 1.0283 -2051 4 13.898 22.318 38.1378 10.5436 5.15112 27.5343 -2052 6 28.757 19.5278 21.8422 22.1809 -34.574 6.30338 -2053 4 29.5381 18.8977 21.7155 -30.335 22.4331 6.48321 -2054 4 28.5907 19.9346 20.9925 4.65837 4.37905 -10.6157 -2055 6 8.3499 21.6369 36.3971 -4.18721 -6.14707 -6.4426 -2056 4 8.67403 22.5346 36.3601 -3.60933 11.4321 4.1017 -2057 4 7.70004 21.5677 37.1222 1.54916 7.87236 -6.53046 -2058 6 39.9526 23.9745 15.2115 13.6309 -13.3423 -31.903 -2059 4 40.8439 23.5703 15.3899 -24.3155 14.8143 -11.3375 -2060 4 39.7878 23.9253 14.2154 4.70535 3.62281 36.021 -2061 6 8.1527 38.6897 22.5283 9.69445 13.3876 41.2978 -2062 4 7.76273 39.4363 22.0797 -11.7526 5.15604 -12.9046 -2063 4 8.4358 39.1168 23.3873 -5.25998 -17.8667 -18.7912 -2064 6 10.8496 20.1728 28.9641 16.4592 -1.26099 15.6701 -2065 4 9.98954 19.7606 29.0198 -7.88942 -4.93169 1.40711 -2066 4 10.9743 20.477 28.0788 -3.54014 6.836 -18.3013 -2067 6 36.8958 23.8215 41.8184 -11.2791 50.4956 -15.8947 -2068 4 37.6092 23.2626 0.106032 31.5333 -36.7229 14.8491 -2069 4 36.0533 23.398 41.8576 -15.1401 -19.7994 6.87638 -2070 6 23.7844 40.6753 33.3645 25.4398 -8.90266 -26.6636 -2071 4 23.0047 40.9559 33.8219 -17.4738 3.31201 10.6553 -2072 4 23.8864 39.707 33.5122 -4.88896 17.7845 5.86364 -2073 6 4.67086 19.2968 35.4027 23.2175 14.2952 24.1117 -2074 4 5.52557 19.1329 35.8895 -25.1286 -0.194605 -14.6261 -2075 4 4.47498 18.5363 34.8535 5.06934 -11.7578 -4.1199 -2076 6 9.45318 25.7818 10.8943 -12.0967 -8.54473 -2.48434 -2077 4 9.17249 24.8577 10.8042 5.18757 -1.88658 7.00696 -2078 4 8.69489 26.2739 10.5541 4.04726 3.8113 4.64502 -2079 6 27.2856 22.4903 13.6084 -4.27813 -9.26261 -11.4963 -2080 4 27.1477 21.7546 14.2243 0.799228 0.372191 -1.31996 -2081 4 27.4324 22.0688 12.7356 2.14896 10.5831 15.5277 -2082 6 41.0369 18.7679 23.2817 21.3973 -17.1333 -11.6606 -2083 4 40.4805 18.1775 22.7581 -1.93352 7.79722 7.02989 -2084 4 40.5302 19.4817 23.6332 -16.07 12.1618 6.58845 -2085 6 46.4867 28.3511 20.139 19.5633 -2.73425 79.1757 -2086 4 45.7489 28.0125 20.7058 1.11057 9.83041 -23.9354 -2087 4 47.2126 28.3766 20.859 -22.6454 6.05643 -47.0217 -2088 6 14.8422 15.3983 30.0672 9.57922 -13.7488 21.5316 -2089 4 14.7114 15.4303 29.1407 -5.18406 2.12307 -31.6519 -2090 4 14.4223 14.5569 30.327 1.67929 11.6926 7.32181 -2091 6 23.5155 24.7614 35.2027 10.8097 10.1661 11.7756 -2092 4 22.8249 25.3921 35.4883 8.74662 -8.07224 -2.50931 -2093 4 24.264 24.8574 35.8273 -14.1502 1.20627 0.95778 -2094 6 19.9045 24.2066 28.4368 -7.08314 38.6572 -15.5481 -2095 4 20.1199 25.09 27.9887 -7.53461 -31.417 18.3002 -2096 4 18.948 24.2479 28.615 8.77669 -1.27719 -1.90381 -2097 6 45.9703 7.63062 20.2339 -9.12647 -14.8446 45.7383 -2098 4 46.0314 7.87281 21.2057 4.66889 -10.1155 -32.2433 -2099 4 46.2124 8.39508 19.7344 6.23892 21.3693 -9.48098 -2100 6 38.0366 12.4686 8.28298 -82.8488 23.4696 -21.0017 -2101 4 37.3097 13.1608 8.47894 48.7672 -25.4087 1.47773 -2102 4 37.4891 11.9231 7.63396 42.6716 2.94367 19.7224 -2103 6 46.9352 18.181 8.45984 -29.3266 9.95329 16.0714 -2104 4 46.1825 17.5598 8.49993 9.84889 1.25457 2.04897 -2105 4 47.3911 17.9594 7.65971 14.7535 -7.6497 -21.4463 -2106 6 10.8592 13.9727 9.37152 -3.14543 -2.30259 -2.26695 -2107 4 10.3309 14.6626 8.91794 11.6563 -8.1882 2.6931 -2108 4 11.7607 13.9013 8.99546 -12.5287 13.781 2.06755 -2109 6 34.3902 5.43491 14.0826 12.6346 -17.837 -1.14204 -2110 4 35.1666 5.80709 13.6695 9.45544 21.1547 -1.41353 -2111 4 34.3397 4.58795 13.6148 -10.7305 -5.41844 9.88093 -2112 6 0.19016 0.223418 22.9526 3.77382 -24.7853 -3.01602 -2113 4 0.21308 41.6498 22.1069 2.59646 7.80057 12.2766 -2114 4 54.882 1.08863 22.7473 -12.4607 27.7599 -7.08256 -2115 6 40.9349 30.5562 37.8906 -27.573 -19.5948 34.9696 -2116 4 40.0494 30.8463 38.2359 23.4276 0.414778 -20.0189 -2117 4 41.1198 29.7844 38.4793 13.2677 19.1991 -19.1849 -2118 6 16.6358 17.3088 12.6818 26.7235 26.3695 -9.20965 -2119 4 16.2617 16.4703 12.4231 -8.92935 -8.7699 -0.695474 -2120 4 17.0088 17.6771 11.8494 -7.35458 -7.68048 15.4997 -2121 6 29.681 5.43286 24.7605 9.99716 1.48249 -7.0405 -2122 4 30.3348 5.91815 24.2382 -0.696307 0.629534 -2.6419 -2123 4 30.0075 5.55596 25.6632 -4.07672 -1.78023 1.29455 -2124 6 49.8902 0.287541 27.2058 21.9743 -13.7053 4.20571 -2125 4 49.8511 0.519591 26.2742 -5.37584 5.48457 -4.26768 -2126 4 50.7946 41.8257 27.2858 -12.157 4.98657 1.57708 -2127 6 31.2412 31.7366 15.2127 13.4193 29.9729 -4.01619 -2128 4 31.644 30.8863 15.3566 3.05611 -13.2507 6.82249 -2129 4 31.9953 32.37 15.1128 -22.0385 -12.9049 3.52444 -2130 6 35.7903 24.1511 16.9464 13.6459 1.10276 -6.74723 -2131 4 35.6731 24.9832 16.4455 1.01595 -13.8109 1.97492 -2132 4 36.7089 23.8312 16.7527 -22.9866 2.97508 8.81266 -2133 6 24.2751 4.63968 36.7374 -16.5997 -22.3051 -33.4925 -2134 4 24.7608 5.22686 37.2962 14.6544 10.0168 10.4919 -2135 4 24.7016 4.68474 35.8573 -7.94113 -0.389021 16.9181 -2136 6 17.5636 12.9031 3.65869 27.6744 1.86844 -28.0383 -2137 4 17.6858 13.5605 2.94059 1.9993 -16.4932 11.4828 -2138 4 16.8984 13.3068 4.18363 -27.8054 1.98581 18.3397 -2139 6 4.17446 14.2934 18.2709 12.2351 -24.5699 -15.5283 -2140 4 4.25201 13.3082 18.1842 -5.45348 23.7329 4.34334 -2141 4 3.28482 14.5076 18.5604 -13.4286 -3.54266 5.37394 -2142 6 19.1793 36.8557 22.3908 -6.26797 4.12828 -2.16449 -2143 4 18.7803 36.3059 23.064 -4.74301 -7.71326 18.3965 -2144 4 19.5341 36.2254 21.7686 7.87239 -11.0625 -9.31555 -2145 6 15.659 11.9578 13.1999 9.98626 24.0921 3.91449 -2146 4 15.6233 12.8387 12.7526 3.08695 -23.3335 12.0049 -2147 4 16.532 11.8904 13.6603 -13.5492 -1.68197 -15.0215 -2148 6 24.7583 21.9129 5.36621 -52.0449 4.43235 28.4012 -2149 4 24.9756 21.6947 6.28233 10.5491 3.37037 -1.58044 -2150 4 23.7611 21.9216 5.43181 35.5612 -5.35731 -13.8865 -2151 6 52.741 18.5708 35.2268 19.1809 2.02674 5.12186 -2152 4 52.5591 18.101 34.4104 -23.468 -7.47943 -3.72799 -2153 4 51.9957 18.6447 35.8177 -20.5936 -5.49273 0.0575333 -2154 6 3.56038 27.2788 25.2921 -16.6903 -17.6792 -11.4043 -2155 4 3.96469 27.2185 26.149 7.10467 -3.13705 18.347 -2156 4 3.97939 27.9962 24.8424 10.8751 21.6711 -8.62461 -2157 6 34.4448 32.9974 30.68 48.2331 9.00339 -1.41906 -2158 4 33.5189 32.8245 30.8394 -9.09046 9.48004 8.12592 -2159 4 34.8804 33.6211 31.3233 -29.3839 -17.782 -5.29467 -2160 6 35.2611 23.7526 9.83248 5.28039 9.63542 14.9856 -2161 4 34.4624 23.9143 9.32096 3.45609 1.41047 -6.97204 -2162 4 35.624 22.9154 9.5528 3.26088 -11.8232 -8.34585 -2163 6 42.4243 15.7233 8.97763 12.8326 1.39623 12.6931 -2164 4 41.658 15.328 8.60072 -22.8346 -8.994 -22.1277 -2165 4 42.104 15.9534 9.85586 1.77226 3.68974 5.84069 -2166 6 7.76866 28.8533 32.9548 -11.0049 17.2013 -15.4709 -2167 4 8.04862 28.1203 33.4848 1.42969 -15.0059 16.0601 -2168 4 8.50079 29.0495 32.3677 8.58058 4.20069 -3.59376 -2169 6 17.6953 41.2515 36.4663 -11.3067 -18.3758 74.5383 -2170 4 16.8889 41.7296 36.6796 -1.19906 6.43806 -6.60961 -2171 4 17.8689 41.3412 35.574 12.2332 11.1792 -57.8962 -2172 6 28.5157 24.2416 15.5518 -29.4686 -13.3801 -11.1317 -2173 4 29.0166 24.9984 15.2559 10.2779 3.66755 -9.57255 -2174 4 28.1226 23.7858 14.7645 18.214 7.11075 11.8426 -2175 6 20.955 16.2999 1.15679 52.4547 14.172 -5.31351 -2176 4 20.9215 15.3848 1.33551 1.21723 -32.5558 11.4722 -2177 4 20.0795 16.5686 1.08505 -57.8144 13.7968 -3.85053 -2178 6 31.1684 40.7359 5.3086 9.60886 -48.7905 -14.3252 -2179 4 30.3201 40.4364 4.96776 -1.1434 5.1051 1.34806 -2180 4 31.1111 41.6485 5.46945 -11.8258 44.905 11.395 -2181 6 29.926 24.7744 36.4585 -3.76808 18.8348 4.26027 -2182 4 30.4252 25.4661 35.9713 -7.21832 -13.6313 5.02454 -2183 4 29.9738 23.9763 35.9568 8.68635 -20.1437 -13.5665 -2184 6 8.66863 31.0429 3.90108 5.49181 -25.3701 -11.391 -2185 4 7.74616 30.7992 3.95988 -7.56137 -0.630176 -1.16432 -2186 4 8.75287 31.8877 4.30735 2.25384 31.6916 10.4967 -2187 6 5.52708 32.7014 11.4113 -17.1068 -29.6258 4.38787 -2188 4 4.72561 33.1583 11.715 12.8879 6.23598 -5.09299 -2189 4 5.16474 31.7796 11.3163 19.6841 23.1791 1.24929 -2190 6 45.6525 35.4522 20.4433 4.50188 -15.2767 -13.8779 -2191 4 45.1533 35.403 19.6071 0.884587 3.9764 11.125 -2192 4 46.1815 34.6145 20.4501 -8.61117 18.3435 2.22997 -2193 6 19.5135 2.78077 9.78076 -23.679 -24.2198 -16.6656 -2194 4 19.3296 3.70289 9.60293 -7.62346 7.89228 3.64078 -2195 4 18.7563 2.26696 9.35595 24.4568 20.2801 14.4664 -2196 6 54.9521 9.08257 10.915 1.41457 -13.8994 3.08946 -2197 4 54.8451 8.89609 11.8656 1.69601 3.75098 -5.72792 -2198 4 0.659909 9.73404 10.7859 1.63405 2.05096 5.26063 -2199 6 21.028 26.5613 14.7909 22.3934 -16.1712 -61.6784 -2200 4 21.2545 26.1082 13.8887 -5.63248 33.4215 43.8962 -2201 4 20.0757 26.5096 14.8457 -4.66041 -4.09977 8.40724 -2202 6 14.1565 30.5187 27.5481 43.0568 3.88252 13.2649 -2203 4 14.5478 30.2647 28.4319 -11.7888 3.54471 -30.6513 -2204 4 14.9443 30.8429 27.0102 -33.9181 -6.53128 14.6047 -2205 6 29.8147 17.3367 31.0866 -27.8518 -4.92818 12.2149 -2206 4 30.6554 17.4646 30.6741 20.9401 8.7355 -10.9161 -2207 4 29.248 18.1063 30.9142 12.1966 -0.59561 3.44929 -2208 6 50.8794 17.2985 27.8251 -38.7154 2.44379 -6.74856 -2209 4 49.927 17.6315 27.8951 41.9068 -8.6615 -2.42711 -2210 4 51.4551 17.8493 28.3603 -3.47276 2.02156 5.1771 -2211 6 46.2645 37.0852 13.9854 4.42941 -15.3994 -45.1385 -2212 4 46.1048 37.4162 14.8449 -7.65894 23.339 32.9902 -2213 4 45.682 37.569 13.3645 -0.578519 -6.08013 10.2779 -2214 6 38.1859 37.2676 33.1408 3.52211 -11.0724 24.5555 -2215 4 38.5393 37.4103 34.0404 -6.68303 -10.0954 -6.88307 -2216 4 38.6219 37.9461 32.6369 2.42637 17.4604 -15.0111 -2217 6 41.8357 13.3473 31.1178 -16.0625 23.8584 17.742 -2218 4 41.5851 13.9423 31.8754 7.82637 -22.3228 -20.2899 -2219 4 42.4009 12.6411 31.4368 6.59024 -10.1979 3.85371 -2220 6 46.9027 12.6459 17.8387 -27.1897 30.7666 -32.0186 -2221 4 46.619 13.5972 17.8049 11.7948 -22.8605 3.48595 -2222 4 46.5208 12.2901 16.9886 18.0608 -3.03081 22.7278 -2223 6 32.0582 10.0955 10.6527 -31.4378 50.3229 23.4622 -2224 4 31.7762 9.76632 11.5317 8.81554 -8.40176 -19.9459 -2225 4 31.6698 11.0464 10.7004 29.7372 -48.0302 -12.3835 -2226 6 34.0062 11.3773 6.75186 17.7871 30.589 25.6979 -2227 4 33.4869 10.5999 6.69262 -19.6684 -30.9606 -3.70709 -2228 4 33.8274 11.7035 7.66069 0.227829 -0.558148 -16.2574 -2229 6 45.3288 30.8634 19.4834 2.25993 -0.395596 -7.26595 -2230 4 45.2654 30.706 20.4282 2.85912 -9.1252 8.63447 -2231 4 45.808 30.1003 19.1195 -1.86475 4.39364 7.74954 -2232 6 20.3535 0.575918 7.15275 2.53913 19.7072 2.1264 -2233 4 20.3036 0.62077 8.11765 -6.02971 -5.31178 -3.74759 -2234 4 20.3373 41.5708 6.90351 -3.42232 -20.4047 0.354773 -2235 6 15.9901 39.4523 4.14302 -22.6863 14.3541 -4.96379 -2236 4 15.4898 39.956 3.48033 13.9059 -6.08345 -3.0001 -2237 4 15.6535 39.8695 4.95456 5.06581 -11.7067 3.21286 -2238 6 52.4222 16.4823 25.1021 7.38571 -14.026 0.748627 -2239 4 51.9391 16.8928 25.8315 -3.23714 5.96419 -6.435 -2240 4 52.4547 17.0876 24.3371 -9.72126 -3.91711 12.1205 -2241 6 38.5305 12.9945 3.24722 36.6577 77.8042 9.91619 -2242 4 38.7269 13.7231 3.96388 -16.2716 -45.5952 -32.5571 -2243 4 38.0745 12.2732 3.61889 -23.0516 -27.5087 18.4748 -2244 6 35.1404 29.6968 31.1683 -32.7778 -10.63 75.6098 -2245 4 35.326 30.1595 30.3922 19.5999 28.8984 -42.5223 -2246 4 34.769 30.3505 31.8393 8.36493 -22.8372 -28.4638 -2247 6 9.52941 33.7628 4.86075 -28.4918 10.8311 18.4951 -2248 4 9.24769 34.3211 5.62607 6.24621 -9.23174 -22.6788 -2249 4 10.3628 33.3905 5.10095 17.2263 -8.07265 -0.549435 -2250 6 21.5384 22.0668 20.5377 -8.24916 -13.7408 18.0665 -2251 4 20.8389 22.6833 20.2982 1.69112 5.82217 1.92954 -2252 4 21.3229 21.7148 21.445 5.44386 11.4228 -26.5573 -2253 6 37.5752 11.1922 41.2961 -25.7405 -15.8592 15.4541 -2254 4 38.0284 11.8044 40.7564 10.4246 30.4728 -30.151 -2255 4 38.2644 10.586 41.5433 15.0535 -11.8566 15.4014 -2256 6 33.8981 1.42806 38.7459 -9.94409 -6.93964 -8.18458 -2257 4 33.592 0.608166 38.3248 2.39341 2.703 9.2739 -2258 4 33.9534 1.28552 39.7002 -3.4763 3.29487 -4.45631 -2259 6 4.57081 26.6822 28.0049 6.08842 -57.033 -35.5124 -2260 4 5.0914 25.8197 28.0746 -15.9746 40.4578 4.78317 -2261 4 4.85783 27.3427 28.6052 16.6445 16.915 24.1865 -2262 6 10.2586 0.903759 11.6235 -14.777 -30.5961 35.2813 -2263 4 10.598 1.12099 12.5147 -1.53351 -1.03605 -18.7158 -2264 4 10.5217 1.55247 11.0069 12.731 34.1315 -22.4253 -2265 6 17.6428 19.8087 2.34625 28.3489 11.7442 10.4095 -2266 4 17.8694 20.4455 1.65312 -0.920106 -2.92675 2.15413 -2267 4 18.5186 19.4679 2.66241 -18.7748 -2.39069 -7.57655 -2268 6 32.4269 25.6656 16.4745 -22.7384 46.4686 12.005 -2269 4 32.9526 26.0936 17.1754 -0.693509 -13.2017 -11.5041 -2270 4 32.8268 24.9018 16.1119 18.5502 -33.1172 -3.66835 -2271 6 33.2526 10.6326 0.323883 9.44704 -29.8166 -9.67306 -2272 4 32.8511 9.97264 41.5994 12.5609 21.6724 15.7642 -2273 4 34.1113 10.2426 0.662313 -26.6835 12.0422 -7.05376 -2274 6 4.94395 4.51414 10.1428 13.8645 5.4827 29.102 -2275 4 4.09398 4.95549 10.181 -4.94694 -3.34603 -2.54834 -2276 4 5.29018 4.56097 11.0773 -8.61071 -3.77852 -28.7481 -2277 6 27.0981 16.9726 9.55361 -31.982 10.5528 -14.2027 -2278 4 27.1645 17.5497 10.32 4.78099 0.707575 6.97209 -2279 4 26.2221 17.2303 9.15822 25.9284 -7.90001 11.4222 -2280 6 9.97547 10.5192 19.3751 2.18725 8.20489 55.882 -2281 4 10.4385 9.92127 18.8097 14.3325 -20.7925 -15.5795 -2282 4 10.1136 10.195 20.3283 -2.00877 10.2565 -41.5362 -2283 6 19.5726 8.5313 27.8509 32.1681 -5.32712 19.6321 -2284 4 20.0623 8.73326 28.6965 -13.9453 -3.32017 -28.6613 -2285 4 20.1531 7.88958 27.3718 -16.7413 15.1406 10.2365 -2286 6 47.0715 38.9553 23.1297 -19.9487 1.16408 5.20576 -2287 4 47.6755 38.9992 22.3956 6.55525 -5.77104 -8.99339 -2288 4 46.1921 38.7934 22.7438 5.29072 4.97192 1.21114 -2289 6 19.6864 25.3648 11.2698 -35.9279 -4.62509 3.50742 -2290 4 18.9891 24.6498 11.3772 26.0807 25.4649 -7.71219 -2291 4 19.2193 26.1995 11.535 7.74761 -20.7647 -6.77192 -2292 6 27.3916 13.4622 15.7395 34.9583 -25.2468 -27.4167 -2293 4 26.6227 13.8144 16.1317 -23.8298 14.7279 29.1585 -2294 4 28.0863 13.1847 16.3728 -7.05347 8.15442 -0.924368 -2295 6 18.6718 14.1326 1.43279 -0.407031 -28.5308 -28.57 -2296 4 18.3771 15.0354 1.29678 -0.169849 11.7565 -8.38297 -2297 4 19.1904 13.8513 0.615983 -22.2167 19.1803 27.2908 -2298 6 42.3082 22.0346 32.4819 -45.1257 5.10199 -13.868 -2299 4 42.1064 21.5657 33.301 1.02444 -1.81924 7.74271 -2300 4 41.4227 22.4584 32.2639 35.231 -14.359 4.36271 -2301 6 10.0299 9.44853 2.50633 35.8335 -20.1603 -5.5533 -2302 4 9.22808 9.80314 2.87263 -22.9312 8.40439 12.9687 -2303 4 10.3707 8.71125 3.07205 -18.436 14.324 -8.13067 -2304 6 6.82989 1.45163 22.0085 -48.1074 -31.7833 -34.6048 -2305 4 5.93364 1.52189 21.5813 27.761 13.2569 19.2226 -2306 4 6.99793 0.508973 21.801 12.0554 14.7409 9.93393 -2307 6 11.2802 27.0298 18.9733 1.62982 48.8223 -5.8971 -2308 4 11.8533 27.1031 19.7597 -5.53045 -6.49976 -4.21856 -2309 4 11.2066 27.9871 18.6476 2.337 -33.8373 14.078 -2310 6 41.4807 20.5084 27.2133 -10.1157 30.3313 5.28758 -2311 4 41.6238 21.1535 27.9303 0.1153 -0.646751 -15.7402 -2312 4 41.3475 19.7242 27.7174 2.20222 -28.2193 4.24429 -2313 6 15.4457 24.115 33.4309 -8.0908 -15.9975 4.96928 -2314 4 14.6694 24.1264 34.0087 5.2648 16.329 -3.20307 -2315 4 15.6051 23.1634 33.3621 10.6851 2.75783 3.25666 -2316 6 36.1374 16.3773 10.0083 -2.95201 1.72364 21.0093 -2317 4 36.0354 15.4723 9.6971 0.275369 -1.57281 -6.84486 -2318 4 36.1532 16.3058 10.9756 2.3103 1.89663 -9.38056 -2319 6 51.7249 16.2592 2.09899 -0.8354 -35.479 4.00209 -2320 4 51.3025 16.6477 2.84061 -15.4293 29.383 24.1936 -2321 4 51.7588 15.3279 2.40044 5.70816 13.7616 -13.313 -2322 6 23.409 8.55726 39.7719 39.5062 -11.15 -25.6965 -2323 4 23.7264 8.82822 38.8637 -18.295 -2.70527 32.3134 -2324 4 24.154 8.00621 40.1033 -17.8621 14.2471 -2.43096 -2325 6 36.7611 34.4487 21.1056 -9.59584 -7.71653 -9.58874 -2326 4 37.1943 34.5847 20.2534 -2.45984 1.11901 0.357954 -2327 4 35.8017 34.351 20.9183 13.0848 5.20904 4.89404 -2328 6 14.146 8.88688 27.2949 11.3522 43.6232 -16.453 -2329 4 13.5534 8.17113 27.3093 -27.716 -37.4722 8.68734 -2330 4 15.0033 8.5993 27.5988 11.0136 -4.6565 4.44913 -2331 6 20.6652 37.4903 25.1946 -10.211 -17.9881 -36.0994 -2332 4 20.7454 36.6557 24.6643 4.11278 14.2078 23.4923 -2333 4 20.5382 38.1243 24.4693 3.50396 4.35638 18.4557 -2334 6 28.825 24.4792 30.0383 -7.87557 -12.5525 -14.3175 -2335 4 28.2203 24.3409 29.2957 -5.62902 14.2643 8.72595 -2336 4 29.6177 24.0933 29.6588 14.1928 -3.34691 9.72359 -2337 6 8.38024 12.0023 23.6849 17.6034 -17.8042 43.8798 -2338 4 9.33151 12.0391 24.0095 -25.5352 0.9508 -22.7134 -2339 4 7.93543 11.4413 24.3789 8.15752 13.9726 -18.9857 -2340 6 16.0957 26.6613 22.9482 -4.23776 -4.88874 3.00129 -2341 4 16.4041 25.8866 22.4682 2.11349 3.20317 -0.347462 -2342 4 15.2797 26.4088 23.4009 6.04671 4.79823 1.078 -2343 6 22.346 41.3881 9.48723 24.9275 -16.664 -2.62618 -2344 4 22.5706 0.299269 9.06271 5.87112 18.1013 -4.15908 -2345 4 21.5005 41.5154 9.87839 -30.5435 3.49176 4.55444 -2346 6 49.3776 19.1851 32.3736 41.1751 -38.6142 12.6649 -2347 4 49.9515 18.5305 32.8666 -19.8114 22.1793 -24.5398 -2348 4 48.9751 19.6643 33.0815 -18.7203 16.5505 12.5326 -2349 6 29.672 28.434 31.2292 -0.0990093 -59.7528 33.1636 -2350 4 30.5672 28.114 31.0525 8.33151 24.242 -15.2883 -2351 4 29.4026 27.6233 31.7702 -3.76231 36.9508 -17.5145 -2352 6 5.09757 39.1181 23.5694 28.9365 -16.8561 66.257 -2353 4 5.426 38.785 24.4883 -20.96 9.44698 -53.4069 -2354 4 5.17377 40.064 23.6953 -4.19226 13.7611 -6.16678 -2355 6 42.9396 13.594 41.6013 33.1291 -45.1938 12.1175 -2356 4 42.8466 14.3322 41.0449 -16.6361 37.6348 -21.2948 -2357 4 42.1546 13.3797 0.17078 -22.3633 5.8076 7.08965 -2358 6 21.2201 12.4318 7.37385 41.5974 -14.6934 -10.3279 -2359 4 20.2896 12.3563 7.35505 -36.2241 5.92132 -7.85999 -2360 4 21.5284 11.6004 6.96932 1.7608 11.2928 4.8084 -2361 6 43.1404 26.8989 37.6922 38.0431 -66.5876 34.8581 -2362 4 42.455 26.3454 37.3085 -15.3628 11.0452 -11.3741 -2363 4 43.7284 26.1839 38.1775 -25.099 52.0029 -25.4853 -2364 6 19.5406 10.6485 41.687 -7.00401 -34.9019 -10.1363 -2365 4 19.0738 10.6767 0.596923 -7.19888 -1.38148 21.2635 -2366 4 19.8536 11.5162 41.559 12.2515 43.5875 -9.13673 -2367 6 53.6223 10.061 3.2559 12.5469 7.56169 -12.6981 -2368 4 54.2024 10.8465 3.22155 -5.5124 -7.95383 7.8004 -2369 4 54.0687 9.40413 2.68363 -10.8512 12.6529 5.34221 -2370 6 17.5742 20.1926 28.4231 -27.2496 23.4973 23.4861 -2371 4 18.0413 19.6307 27.8376 17.787 -14.8025 -21.0857 -2372 4 18.1273 20.2938 29.2048 3.54631 -0.489564 0.0042962 -2373 6 36.884 7.32584 1.68504 -56.6071 21.2656 -14.3658 -2374 4 37.7051 7.59774 2.01592 38.2946 9.18211 20.2394 -2375 4 36.4748 8.1931 1.44071 3.42518 -20.8507 2.42249 -2376 6 29.2181 41.4159 1.83346 -7.01124 13.363 14.2223 -2377 4 28.4272 0.01466 2.15652 15.3791 -9.50345 -13.4545 -2378 4 29.1899 41.2946 0.880744 -4.61983 7.49126 -6.31737 -2379 6 13.5157 3.09172 8.12958 -12.3356 7.91728 -16.4605 -2380 4 12.824 3.78046 8.01164 12.4629 -9.10221 7.3254 -2381 4 13.8551 3.1491 9.02604 -1.1531 -1.24526 3.73064 -2382 6 15.0243 29.578 18.5071 -0.689822 5.1468 -1.91807 -2383 4 14.6889 28.924 17.8685 -1.8514 4.35612 11.642 -2384 4 14.2858 30.1508 18.7969 8.46412 -5.78667 -10.3485 -2385 6 10.5031 24.7013 24.3729 39.9308 52.3958 -21.489 -2386 4 10.8696 24.6855 23.439 -22.6214 -1.85919 30.3756 -2387 4 10.1444 23.8694 24.566 -23.1097 -44.7323 0.689524 -2388 6 2.33043 13.8499 25.1512 12.2217 -8.49201 10.1592 -2389 4 1.51988 13.5482 24.7402 -5.80441 -9.83551 -11.7005 -2390 4 2.2572 14.7938 25.1495 -10.3249 16.8303 -2.61333 -2391 6 31.8608 32.7615 29.8175 -5.917 1.92483 -13.0568 -2392 4 30.9148 32.9142 29.9093 1.86919 3.45723 4.06263 -2393 4 31.9038 31.8703 29.4643 1.33296 -6.10517 -4.90202 -2394 6 37.5413 40.8309 33.9785 -53.8639 -49.1526 -10.38 -2395 4 37.2515 40.0243 34.5353 23.0474 40.5808 -8.35317 -2396 4 36.818 40.8104 33.2846 24.4839 11.2763 19.2644 -2397 6 24.0486 38.1463 34.3459 4.38709 -25.8386 -29.9356 -2398 4 24.1932 38.0251 35.2675 1.20986 12.6476 31.9448 -2399 4 24.4562 37.3431 33.9843 -4.45208 9.66559 -5.62065 -2400 6 37.1813 22.5726 7.37313 12.7367 -26.0408 21.8779 -2401 4 37.6868 21.7363 7.50199 -14.9443 17.386 1.08188 -2402 4 37.2974 22.7741 6.46124 2.1827 3.60906 -24.8808 -2403 6 4.31908 23.2435 35.594 -25.7168 -2.52913 6.61784 -2404 4 4.31865 22.3787 35.1609 -1.33991 4.89576 -0.266123 -2405 4 3.37757 23.4898 35.7698 13.7393 -2.9658 -3.46645 -2406 6 15.7444 14.893 2.66063 14.3192 36.2435 46.5189 -2407 4 15.9445 15.8567 2.71494 4.00237 -25.0016 7.78932 -2408 4 15.3014 14.8369 1.84861 -12.1852 -13.1154 -36.1328 -2409 6 48.1607 23.1823 2.03014 17.998 -4.54201 -11.9107 -2410 4 48.5744 23.458 2.84259 8.43731 2.94545 12.5813 -2411 4 48.9225 22.9045 1.46682 -22.9697 5.41467 1.46601 -2412 6 24.1212 19.9771 21.5555 -13.5297 -6.85262 15.9953 -2413 4 24.2241 19.3198 22.2577 -12.7792 13.8262 1.69378 -2414 4 24.7627 19.6352 20.9706 23.452 2.79195 -33.2435 -2415 6 10.5793 29.3754 5.15175 -1.75103 26.9922 -14.4666 -2416 4 9.93004 29.8841 4.64694 -13.9608 -12.0643 5.47156 -2417 4 11.3599 29.8389 4.86113 16.4531 -5.21099 6.28998 -2418 6 5.96767 27.6933 31.2336 10.2296 -18.0279 -26.5205 -2419 4 6.63185 27.1353 30.7398 -17.0624 11.0978 13.8341 -2420 4 6.49058 28.2721 31.7915 6.44996 0.578865 12.7715 -2421 6 18.5397 25.8071 15.3312 30.8629 -17.2743 -78.9847 -2422 4 18.3277 25.7099 16.2038 -28.7942 6.39581 79.7195 -2423 4 17.897 26.3418 14.8644 -17.4943 11.9017 11.8989 -2424 6 52.0949 37.2335 11.1138 -0.736115 -25.1617 0.200807 -2425 4 52.5552 36.4743 10.7101 2.49656 11.0988 9.7325 -2426 4 52.7586 37.8745 11.3958 -2.29245 7.10647 -7.85035 -2427 6 46.8562 14.6296 7.3094 -39.0502 -6.9365 63.794 -2428 4 46.1382 15.0906 7.8718 34.2719 -4.68193 -40.7336 -2429 4 47.0431 13.9061 7.9424 14.2062 7.46383 -20.3992 -2430 6 22.2508 0.698906 41.6783 16.129 -5.34947 -25.8041 -2431 4 22.2008 1.66415 41.7125 4.72421 -6.65403 -6.59212 -2432 4 22.9559 0.389699 41.0229 -20.0941 20.4891 31.5318 -2433 6 4.05761 14.7345 9.27152 -10.7438 13.6286 -6.0443 -2434 4 3.56043 15.5915 9.15395 12.8436 -23.8424 -1.56379 -2435 4 4.93811 14.8828 8.92118 3.87558 5.66633 -1.10852 -2436 6 37.2917 12.6666 37.0157 -30.741 -16.0859 47.3668 -2437 4 37.7371 12.676 37.8973 0.89189 9.6387 -16.8975 -2438 4 36.3707 12.3712 37.2872 32.4569 8.65188 -22.8431 -2439 6 26.6682 29.0903 40.5985 -18.9168 16.4285 3.4146 -2440 4 27.032 28.2632 40.812 19.8197 -36.7417 16.2821 -2441 4 26.6469 29.0593 39.6552 2.37875 14.8387 -20.8034 -2442 6 7.22455 13.851 3.31845 32.6668 -55.3021 -17.7697 -2443 4 8.0198 14.2759 3.60088 8.05656 35.1068 9.02454 -2444 4 7.66854 12.9807 3.04146 -45.3946 28.1811 11.8363 -2445 6 8.95271 34.8627 28.8342 33.802 -52.1542 -15.9648 -2446 4 9.89817 35.0055 28.6074 -18.5208 0.484683 7.95646 -2447 4 8.56267 35.6958 28.9173 -17.8026 46.8286 13.0667 -2448 6 37.1756 40.0691 40.1061 46.0034 7.56439 6.60252 -2449 4 36.245 40.1688 40.0074 -20.2243 -4.13511 -1.70673 -2450 4 37.2907 39.5142 40.8911 -6.64471 -1.97244 -3.69085 -2451 6 30.3689 6.165 27.2364 16.9392 12.8422 63.3115 -2452 4 30.1126 5.75506 28.1249 0.00544273 9.78172 -37.0876 -2453 4 31.0397 6.83064 27.5702 -18.6179 -11.6186 -23.6342 -2454 6 10.4791 22.885 18.2972 2.22892 -25.7937 -34.5052 -2455 4 11.3494 23.0331 18.653 10.7715 4.73748 7.10061 -2456 4 10.6446 22.3032 17.5049 -10.188 21.0769 23.5682 -2457 6 35.8886 14.2524 40.1239 38.6938 29.9036 -1.43051 -2458 4 35.4161 14.6576 39.3846 -1.71718 -13.5804 13.4977 -2459 4 35.4021 13.6019 40.5864 -31.0402 -18.1501 6.5583 -2460 6 6.71723 1.08854 17.7001 -3.83901 -60.8198 25.71 -2461 4 6.23156 1.19942 18.5167 -3.21909 18.7445 0.671973 -2462 4 6.88149 0.099135 17.7878 0.895752 34.2898 -15.7018 -2463 6 41.3468 34.0461 33.1794 10.5682 19.0983 -18.7578 -2464 4 40.4721 34.2712 32.8864 -29.2649 -1.70533 3.43004 -2465 4 41.8357 34.5632 32.5195 11.425 -3.18121 9.05585 -2466 6 37.2595 0.990816 41.287 9.45411 17.3584 -9.40071 -2467 4 37.687 0.20533 40.9743 -1.4253 -22.058 -8.3634 -2468 4 37.4586 1.01742 0.30817 4.28067 1.92511 18.4856 -2469 6 25.2602 30.9527 6.20609 -41.9214 10.7977 -12.9978 -2470 4 25.877 31.4326 5.6764 28.9604 0.775163 -4.96937 -2471 4 24.4759 30.9469 5.60333 12.4846 -9.23957 25.2824 -2472 6 14.2056 24.502 28.3086 -25.5247 14.5131 -24.5719 -2473 4 14.1882 23.6623 28.7056 13.4522 -31.4953 30.087 -2474 4 13.7133 24.2842 27.5041 7.94148 19.2098 -3.82225 -2475 6 34.2051 26.2238 36.0112 -48.9031 41.3361 24.9979 -2476 4 35.1144 26.3624 36.1822 32.7561 -2.50775 4.45543 -2477 4 33.7446 26.9807 36.5344 19.2218 -36.9328 -23.3608 -2478 6 32.3568 8.33098 28 25.7802 40.2385 3.20277 -2479 4 32.7565 9.24505 28.063 -37.9579 -17.4528 3.85033 -2480 4 33.1461 7.94224 27.6538 8.5967 -27.8742 -9.28785 -2481 6 11.7867 0.286536 26.9724 -1.3913 -35.2382 4.72224 -2482 4 11.7865 41.2385 26.6946 0.846362 23.7064 4.93964 -2483 4 11.6054 0.272418 27.9282 2.03777 4.09428 -12.4872 -2484 6 1.68124 0.254113 10.3309 8.7986 -13.2184 -15.0921 -2485 4 1.59717 41.2916 10.7333 -0.0350141 -2.89412 -0.990995 -2486 4 1.41389 0.849687 11.0071 -7.7361 15.4014 20.6266 -2487 6 6.75173 13.8377 8.23874 -3.6693 30.6435 -30.4665 -2488 4 6.43924 13.9799 7.29904 9.51956 -14.6006 30.1073 -2489 4 7.1653 14.6974 8.43116 5.95594 -9.45057 4.81521 -2490 6 22.2348 20.5564 6.16471 -24.0844 -9.72934 13.195 -2491 4 21.6727 21.3518 6.25881 9.87637 -7.56006 0.262552 -2492 4 21.7029 19.8181 6.55593 11.5262 14.9976 -6.6436 -2493 6 17.385 20.4497 10.8769 -35.9329 27.9153 -37.8305 -2494 4 16.5515 20.156 10.4074 25.3596 -4.97581 21.0147 -2495 4 17.441 21.3848 10.5386 11.6957 -25.2138 21.3318 -2496 6 17.7006 4.52737 19.573 -11.3777 -34.9061 -6.08889 -2497 4 17.032 4.43128 20.2569 -5.49224 11.1956 3.68583 -2498 4 17.4813 3.72403 19.0236 15.4315 33.5846 4.92098 -2499 6 0.483339 18.1114 40.0861 11.4726 -7.5634 -25.4826 -2500 4 0.218803 18.6551 40.8031 -6.40406 19.3 17.6992 -2501 4 1.29471 18.4968 39.6981 -7.50073 -9.94226 4.45973 -2502 6 22.9439 24.8131 27.8304 -1.07592 37.7895 -56.3844 -2503 4 22.8309 25.5845 27.1671 -0.125595 -37.7338 24.1587 -2504 4 22.7938 25.2149 28.6606 -3.1997 14.6603 34.334 -2505 6 42.7926 39.1547 26.7662 4.75434 20.2168 6.00074 -2506 4 43.0175 38.5002 26.1242 -2.01943 -24.6309 -11.9253 -2507 4 43.3024 39.9142 26.4608 -1.73796 0.515913 11.2644 -2508 6 26.2338 3.05974 21.8008 -0.713756 21.3652 -6.58596 -2509 4 25.6341 3.75271 22.1513 17.432 -13.3686 -8.49125 -2510 4 26.841 3.50549 21.1637 -15.4189 -7.95734 10.2455 -2511 6 54.5913 9.88629 29.5891 14.6194 -0.200122 15.6168 -2512 4 54.0185 9.11016 29.6389 -2.18077 1.53735 0.0476299 -2513 4 54.8498 10.0557 30.5251 -12.748 -2.88746 -21.9109 -2514 6 24.7662 33.7505 20.5324 -4.4887 -11.5901 7.32024 -2515 4 24.6764 34.6709 20.8407 -1.82029 -5.26135 -2.53883 -2516 4 23.9322 33.4503 20.1388 -0.463927 12.2923 -3.35723 -2517 6 41.7034 16.3049 0.90063 -4.83399 22.4927 -47.1255 -2518 4 41.2734 15.9533 1.64089 -16.394 -13.425 40.883 -2519 4 42.6233 16.3659 1.12415 18.2298 -9.67465 4.77205 -2520 6 23.3998 27.9207 27.4832 -10.7606 37.0497 -28.3533 -2521 4 22.8282 28.3407 28.1441 5.00816 -9.79407 0.156118 -2522 4 23.2556 28.495 26.6632 8.58882 -24.5485 28.392 -2523 6 32.7859 37.2984 18.7364 25.7014 -40.2058 6.96479 -2524 4 33.7401 36.9719 18.7703 -32.5146 22.7172 4.70252 -2525 4 32.7784 38.1932 18.4283 6.4981 19.1078 -10.0488 -2526 6 21.2249 27.6889 4.78917 1.7584 -25.2435 -20.8654 -2527 4 20.596 27.4146 5.46499 -5.42949 1.48454 -4.75098 -2528 4 21.0369 27.1287 3.96943 -0.427807 22.4392 26.4825 -2529 6 54.9457 17.9605 1.83049 24.1732 12.1415 15.992 -2530 4 54.6765 17.1472 1.44643 -11.2843 -21.2768 -12.0273 -2531 4 54.1938 18.5428 1.86671 -18.1074 1.0363 -7.50679 -2532 6 36.7435 10.702 6.59289 -49.1612 2.30359 2.88264 -2533 4 35.7736 10.9925 6.66913 36.3355 -9.83622 -8.29906 -2534 4 36.7226 9.77144 6.87602 6.19961 4.27664 0.325158 -2535 6 54.2959 4.49421 14.021 -47.0247 26.1641 -8.2037 -2536 4 53.712 4.99768 13.3924 28.2438 -8.88077 8.93165 -2537 4 53.834 4.66365 14.8572 10.6634 -9.95324 4.36694 -2538 6 22.1071 12.8195 32.0067 31.7906 8.9597 -11.0311 -2539 4 21.2967 13.3066 31.9589 -27.922 0.108445 -0.906739 -2540 4 22.6887 13.2954 31.3728 -6.4895 -15.5456 16.1837 -2541 6 15.3021 36.6565 4.03444 -21.8215 23.8176 13.2077 -2542 4 15.3262 37.6185 3.88215 -1.10116 -7.72226 9.53853 -2543 4 16.0423 36.3695 3.52653 17.7184 -15.2462 -10.6327 -2544 6 23.951 1.27123 5.71091 12.3119 19.4094 13.4558 -2545 4 23.1735 0.716989 5.76524 -11.3354 -5.61231 -0.786433 -2546 4 24.0519 1.77027 6.55293 -6.00641 -12.6326 -15.7345 -2547 6 14.2792 12.648 15.8066 19.0644 9.13243 11.8341 -2548 4 14.5911 12.5731 14.893 -12.6174 -10.6299 -3.28453 -2549 4 13.3818 12.3002 15.9605 12.2346 2.97194 -15.7557 -2550 6 15.0388 40.2481 6.5891 -30.9219 -16.0267 -20.9978 -2551 4 15.8926 40.3583 6.97574 17.8619 16.6743 19.574 -2552 4 14.4622 41.0349 6.73493 18.0926 -11.8876 3.06612 -2553 6 48.5605 32.6308 12.0872 21.4935 -15.1737 -19.6402 -2554 4 48.2882 31.8163 11.6222 -11.7375 10.5522 8.8403 -2555 4 49.3772 32.8772 11.5869 -20.063 0.749688 13.0696 -2556 6 11.2909 31.5377 7.21713 -14.6129 -9.26005 -15.8818 -2557 4 10.6224 30.9548 6.78826 17.7824 9.96971 10.6082 -2558 4 11.6163 32.1134 6.50388 0.884245 -9.77636 6.63484 -2559 6 30.1231 27.9968 10.2226 9.10006 8.28679 -14.6513 -2560 4 30.718 28.7273 9.95045 -8.34799 -9.59518 10.9295 -2561 4 29.9727 27.4897 9.40845 -5.6962 -0.318113 1.27302 -2562 6 27.6759 22.1164 17.3809 2.93811 -8.1883 -22.8269 -2563 4 27.2909 21.5233 16.7142 1.55949 -2.9899 10.1125 -2564 4 28.0309 22.8242 16.8263 2.77593 4.45495 11.6125 -2565 6 12.9654 4.59514 18.1625 -0.934721 -11.3223 -0.518608 -2566 4 13.4589 3.798 18.4727 -12.2499 12.1104 -13.3514 -2567 4 12.4628 4.36939 17.3497 12.7979 1.84773 4.27522 -2568 6 19.7203 6.71654 19.0744 25.855 21.5282 16.2244 -2569 4 18.977 6.16103 19.2554 -18.9537 -21.446 -0.739234 -2570 4 20.1996 6.78409 19.9214 -9.72031 -0.922856 -11.6068 -2571 6 37.1527 31.3787 11.4669 20.5156 -3.08539 55.9419 -2572 4 36.5467 31.6235 12.1801 -19.4555 -0.126446 -17.2692 -2573 4 37.8531 31.0173 12.0578 -6.7166 -8.42047 -30.0342 -2574 6 3.11862 16.2015 27.3491 -14.8948 -19.7352 -9.46107 -2575 4 2.52427 15.4561 27.6487 20.3886 21.5408 -12.2486 -2576 4 3.15348 16.212 26.3649 -6.24389 -0.0501167 23.7097 -2577 6 15.7133 9.97724 38.3591 30.328 17.4212 13.8857 -2578 4 16.1258 10.8398 38.0549 -11.3336 -30.4403 16.2583 -2579 4 16.257 9.66317 39.1359 -16.0932 10.0631 -23.9552 -2580 6 13.4043 14.2884 8.2363 15.0986 25.1191 -5.83206 -2581 4 13.804 15.2225 8.33958 -5.13839 -47.7054 6.28407 -2582 4 14.0947 13.5837 8.31616 -11.6402 16.8216 1.41307 -2583 6 1.71524 24.3141 36.392 36.4901 -22.2748 31.9402 -2584 4 1.86474 25.1068 36.8985 9.35176 9.25273 5.49175 -2585 4 1.1215 24.6177 35.7571 -36.8309 10.6894 -41.0698 -2586 6 11.1862 26.5319 32.9688 15.239 -24.9993 36.2438 -2587 4 10.9649 26.8002 32.096 -11.5382 16.0703 -24.8314 -2588 4 11.1647 27.266 33.6054 -7.17864 1.89937 -11.754 -2589 6 29.5773 0.765668 36.2911 32.6527 8.9619 33.1448 -2590 4 29.1495 0.596705 35.4758 -23.483 -6.97315 -25.4485 -2591 4 28.9625 1.07408 36.9696 -5.35236 0.153158 -12.2969 -2592 6 43.6099 13.1071 23.908 -7.75428 16.7256 -33.2383 -2593 4 42.8302 13.3868 24.3919 -4.08537 -1.1131 9.93358 -2594 4 43.3622 13.2586 22.9511 7.4693 -9.27191 32.0602 -2595 6 7.44309 19.7767 19.6705 17.8438 12.6527 -6.23579 -2596 4 6.73015 19.1919 19.919 -3.61392 -10.9972 -0.189724 -2597 4 7.6227 19.7194 18.722 -11.1837 -0.704544 3.42764 -2598 6 24.4259 4.29913 7.83629 -8.5248 -0.10499 -3.36953 -2599 4 24.144 5.21077 7.98541 -0.150025 -7.47068 -3.31634 -2600 4 24.9904 4.0546 8.57206 4.90899 -0.271036 -1.18338 -2601 6 51.4883 30.2308 31.1674 -14.7545 1.56633 -0.747328 -2602 4 50.5925 29.8847 31.2768 -1.35209 3.55691 8.49804 -2603 4 51.5844 30.2463 30.2146 11.2248 2.3182 -11.9335 -2604 6 0.913373 23.6795 16.8764 44.9279 -35.4578 23.1065 -2605 4 0.053834 23.3329 16.7065 -24.7033 4.18361 -15.1926 -2606 4 1.39802 22.8443 17.1197 -4.68332 28.5423 -3.90241 -2607 6 45.0884 19.3939 15.6913 9.05154 29.148 -44.7311 -2608 4 45.9115 18.9543 15.4906 10.1171 -6.0821 0.331933 -2609 4 44.8041 18.9926 16.4702 -27.3917 -26.115 43.7395 -2610 6 17.5003 8.70625 40.5861 -20.5343 49.5779 -9.15489 -2611 4 18.1762 9.35755 40.8219 0.532033 0.318295 -4.52849 -2612 4 17.8864 7.89597 40.8225 20.4785 -39.0634 11.6529 -2613 6 30.1832 27.259 27.1983 -17.9859 30.5387 -1.70378 -2614 4 31.0843 27.5469 27.0174 5.19664 -5.65516 3.8328 -2615 4 29.6652 28.1124 27.2385 17.8651 -30.9588 0.0373123 -2616 6 43.0672 26.1987 28.3737 -1.21405 11.7795 -35.2128 -2617 4 43.2187 25.7399 27.5308 2.18298 5.51683 1.33219 -2618 4 43.1307 25.5038 29.0079 -1.74848 -11.3154 21.2466 -2619 6 27.987 7.5851 3.0601 9.13665 18.2748 23.7588 -2620 4 28.1896 6.93215 2.40721 -2.30749 -24.2619 -13.6918 -2621 4 28.5512 7.39371 3.84357 -9.52219 0.418204 -9.11945 -2622 6 44.6779 7.22362 10.1855 -3.82519 12.3682 29.7072 -2623 4 44.5846 7.37997 11.1613 -8.64186 4.71212 -23.3906 -2624 4 45.2067 6.43644 10.1815 9.68596 -14.557 -3.94398 -2625 6 23.537 20.3907 32.2607 -4.33975 0.880185 -5.57314 -2626 4 23.324 21.1985 32.7413 -3.519 5.94106 -1.71472 -2627 4 23.9311 19.8373 32.9365 5.99895 -7.24541 1.02787 -2628 6 37.5412 21.0533 29.2807 6.26587 16.0676 16.0196 -2629 4 37.3761 20.3248 28.6837 -16.0493 -11.7352 -10.5522 -2630 4 36.7218 21.4261 29.6708 7.43039 -8.09007 -9.52559 -2631 6 49.2859 29.0787 28.7031 8.16517 -18.5587 -1.11584 -2632 4 48.658 29.8007 28.598 1.09858 8.52384 -10.5349 -2633 4 50.1522 29.3365 28.3345 -7.12297 8.09394 6.40204 -2634 6 47.5144 18.1684 15.2382 -13.098 45.3115 -50.4885 -2635 4 48.063 17.6794 15.7982 26.613 -22.2712 34.0874 -2636 4 48.011 18.9832 14.9644 -13.0138 -21.3801 10.9042 -2637 6 23.2587 11.168 16.5961 -34.2623 -16.0228 11.9175 -2638 4 23.8181 11.8474 16.2701 22.3391 18.1069 -12.9732 -2639 4 23.6107 10.3074 16.3447 5.63526 2.71733 -4.05723 -2640 6 3.14661 8.32736 23.1966 -5.33081 14.6732 5.33529 -2641 4 3.33443 7.84562 22.3891 5.23826 -4.81966 -4.36628 -2642 4 3.62138 9.17513 23.1245 -2.82501 -4.35917 1.75332 -2643 6 0.508878 16.1819 6.17622 16.4304 7.97407 55.7173 -2644 4 1.47866 16.3831 6.12713 -25.5039 -9.61354 -6.44341 -2645 4 0.329178 16.1408 7.1857 2.48639 -0.0834422 -46.7437 -2646 6 43.1796 15.6993 5.84098 -15.9449 -20.1226 -10.4934 -2647 4 42.9586 16.4507 6.36104 0.864404 19.5468 17.3894 -2648 4 44.0486 15.8407 5.47017 17.9332 8.6581 -2.45416 -2649 6 16.7038 35.4743 34.4518 -23.198 12.4372 32.502 -2650 4 15.9504 35.0582 34.0028 7.47206 -3.63127 2.95791 -2651 4 16.3197 35.7905 35.3305 20.1374 -9.24319 -26.2799 -2652 6 38.8854 7.73874 15.6833 27.6202 35.8952 13.402 -2653 4 39.2486 7.07212 15.1014 0.737034 -8.76325 -8.48971 -2654 4 39.6641 8.33099 15.9666 -32.1226 -27.7665 -11.1551 -2655 6 42.0076 36.5182 13.641 -8.45099 16.164 -4.64077 -2656 4 41.9228 35.5752 13.5656 2.538 -16.9665 4.44933 -2657 4 41.1544 36.8356 13.3036 3.7559 4.14555 2.82714 -2658 6 54.2986 15.3848 32.1119 10.5246 -16.1102 10.831 -2659 4 0.035655 15.9755 32.3754 -8.42237 -3.15332 1.00609 -2660 4 53.5781 15.9253 31.7943 -3.3302 7.96061 -4.64421 -2661 6 22.8954 13.9973 39.0304 35.7671 -1.21675 7.49641 -2662 4 23.2761 14.8055 39.421 -4.93619 -7.73369 -6.00904 -2663 4 21.9819 14.1606 38.8837 -32.0989 6.28079 -4.51925 -2664 6 48.0426 28.53 4.78367 -18.7604 -12.0579 33.007 -2665 4 48.5209 28.7824 4.01456 21.1512 11.8238 -22.7946 -2666 4 47.6247 29.3288 5.14776 5.26678 3.3179 -1.38234 -2667 6 48.833 10.6059 2.66638 -9.19187 -9.9608 -41.9733 -2668 4 48.2371 10.184 3.25557 -19.2293 -15.3999 15.8868 -2669 4 49.4018 11.1117 3.19515 27.1663 25.8201 26.2609 -2670 6 17.1043 29.3494 4.41938 0.116954 -3.05469 4.91749 -2671 4 16.3442 28.823 4.73493 -1.75912 12.177 1.49975 -2672 4 17.4207 29.929 5.14153 -0.429925 -17.6765 -0.899977 -2673 6 27.7901 7.33424 26.577 58.6208 -10.7281 -9.65958 -2674 4 28.6921 6.89516 26.6033 -20.1634 35.8081 4.28732 -2675 4 27.2961 6.54785 26.6418 -36.3357 -24.7905 3.70209 -2676 6 18.0242 22.0537 22.5144 -27.9591 -16.1551 -40.0832 -2677 4 18.4878 21.2118 22.5153 10.7066 -2.42354 6.7168 -2678 4 17.4966 21.98 21.6478 21.0889 16.8172 36.9195 -2679 6 22.144 25.0979 16.6837 -22.767 31.6961 -6.75713 -2680 4 21.8754 25.6012 15.8609 3.46788 -12.1894 37.0641 -2681 4 22.4796 24.2953 16.3382 13.1119 -24.3628 -7.92486 -2682 6 25.5147 28.4379 7.13209 -32.2353 18.5879 42.0502 -2683 4 25.3191 28.6153 8.09624 16.8162 -18.2828 -29.7283 -2684 4 25.4949 29.3399 6.82105 5.5127 9.28731 -21.7507 -2685 6 42.5447 24.7469 23.7482 -26.0567 17.8354 -0.260974 -2686 4 41.659 25.0561 24.0862 27.8337 1.55541 -7.56443 -2687 4 42.5141 23.8045 23.8516 -5.7883 -22.6777 0.706816 -2688 6 6.24511 16.6188 2.47068 -21.6781 9.7655 5.77715 -2689 4 5.36273 16.9874 2.41541 -6.24724 13.8235 -1.18511 -2690 4 6.01398 15.7093 2.58331 16.9883 -26.009 1.35247 -2691 6 47.3719 33.28 1.46148 -3.99946 1.01934 -28.2481 -2692 4 46.9803 34.1218 1.66358 -4.59906 12.9067 -8.65937 -2693 4 47.69 33.0389 2.30921 14.6803 -12.3184 23.7614 -2694 6 1.27616 36.1851 24.8829 8.16993 1.58395 -5.27854 -2695 4 0.639753 36.4584 25.5359 -13.8461 11.829 3.50901 -2696 4 1.57271 35.3754 25.2942 10.46 -9.74103 -2.86729 -2697 6 20.9413 29.0442 16.4303 -37.0385 3.95749 11.2157 -2698 4 21.4069 28.5201 15.8013 19.747 -14.8546 -14.4583 -2699 4 21.4101 29.8248 16.6953 16.4704 9.62387 -0.234111 -2700 6 18.6701 32.5426 14.1399 -11.935 -28.2137 10.094 -2701 4 17.8036 32.9051 14.2078 -15.3524 29.2867 2.90472 -2702 4 18.4356 31.618 14.3552 23.1856 4.50503 -1.59621 -2703 6 15.7338 41.7002 0.007017 -29.1796 -38.8659 -6.04008 -2704 4 15.5134 41.1073 41.1476 16.5192 17.684 16.0218 -2705 4 15.1804 41.3134 0.738607 16.9589 18.7767 -12.0866 -2706 6 20.5358 18.4015 7.20723 -36.4209 10.7746 11.3165 -2707 4 20.1727 18.4996 8.12034 18.5895 1.11111 -8.73102 -2708 4 19.7156 18.4439 6.66948 20.5956 -6.66311 2.45516 -2709 6 35.3359 2.82506 1.61733 -4.03181 47.7257 29.2165 -2710 4 34.9541 3.20961 2.47337 19.1106 -23.159 -34.5889 -2711 4 35.8528 3.61912 1.28524 -9.69035 -30.1723 1.40188 -2712 6 49.0059 19.6751 24.9502 -26.306 10.305 -4.58994 -2713 4 49.8292 19.282 24.7191 18.9727 -16.8119 -2.00329 -2714 4 49.219 20.61 24.9195 -6.54834 1.96917 8.98321 -2715 6 26.0427 7.1974 41.5664 19.1127 -25.9459 -27.3591 -2716 4 26.6886 6.46136 41.6822 -6.92827 19.3426 1.38611 -2717 4 25.5576 7.23966 0.456505 -11.7101 6.8047 33.8929 -2718 6 22.0248 3.60461 29.0185 -16.0846 7.25678 -9.40108 -2719 4 21.194 3.80897 28.5456 14.569 -4.87522 0.502932 -2720 4 22.1959 4.40114 29.525 4.81678 0.210141 7.58007 -2721 6 27.8548 32.5394 20.644 30.2008 -27.0251 30.2495 -2722 4 26.9598 32.7332 20.4747 -36.3343 12.7784 -11.814 -2723 4 28.412 33.1097 20.1287 0.615935 11.6015 -11.5439 -2724 6 8.3956 24.7909 3.45677 41.8783 30.6212 2.1827 -2725 4 8.85983 24.2427 2.83372 10.4085 -11.4169 -11.9204 -2726 4 7.65564 24.3184 3.74512 -41.6031 -24.257 6.19876 -2727 6 30.5856 41.7288 15.6573 18.8319 11.6475 40.5199 -2728 4 29.9513 0.161741 16.3149 8.82373 -8.1621 -4.69308 -2729 4 30.0935 41.6309 14.8822 -24.2072 -8.84927 -42.274 -2730 6 48.0984 5.63232 21.2085 -24.8678 -8.67647 -10.7387 -2731 4 47.6235 6.28714 20.6867 8.63769 7.09972 -0.446275 -2732 4 47.3595 5.05066 21.4474 12.3779 0.983941 9.20385 -2733 6 39.4236 23.163 35.7324 -26.6807 -22.8308 -31.4054 -2734 4 39.8477 23.6904 36.3502 31.9199 30.6139 46.0523 -2735 4 38.8623 22.5516 36.2186 -1.29306 -3.58423 7.04543 -2736 6 51.5883 33.3617 5.78995 -19.5798 -55.0773 -18.3228 -2737 4 51.7861 34.2574 5.89467 9.96767 53.6603 7.25336 -2738 4 51.5145 33.1869 4.82901 1.99858 6.27826 11.2132 -2739 6 40.1205 17.6413 30.7797 3.51386 -32.8888 9.0941 -2740 4 39.6335 18.3955 31.0853 6.47279 10.0891 -2.42254 -2741 4 40.8254 17.9321 30.1952 -5.08805 1.72673 -6.80625 -2742 6 46.4235 9.81086 18.5807 -13.6096 13.2326 25.0066 -2743 4 47.164 10.4099 18.4597 3.17276 -2.49269 -0.272695 -2744 4 46.3941 9.2422 17.832 2.02048 -17.819 -25.0993 -2745 6 15.8844 41.0843 31.9336 24.9021 -3.26155 -16.7898 -2746 4 16.5805 40.7078 31.3592 -9.31569 -10.1627 6.74042 -2747 4 16.1791 0.090931 31.8861 -11.051 9.97246 9.22539 -2748 6 48.5496 25.7276 14.9325 -23.4699 4.48431 -20.1118 -2749 4 49.4421 25.9075 14.7294 36.7388 1.67727 3.80263 -2750 4 48.1707 25.827 14.039 -11.0362 0.596064 15.3478 -2751 6 39.2225 28.9892 36.1575 1.81804 -9.3363 -11.5399 -2752 4 40.0459 29.1043 36.6225 6.32097 13.8964 11.0865 -2753 4 39.5169 28.7877 35.2623 -5.25992 -5.15898 -10.721 -2754 6 37.325 21.0738 14.9394 -7.85324 -20.9229 -64.7065 -2755 4 37.9996 20.7799 14.2865 -1.58038 10.9233 26.036 -2756 4 36.5898 21.2349 14.28 11.1979 5.88457 46.2171 -2757 6 32.4971 22.8607 15.7433 -7.91212 -33.4559 24.7905 -2758 4 31.7632 22.4534 15.25 1.55934 10.0805 -2.32687 -2759 4 32.5592 22.2921 16.5663 4.31702 21.463 -27.4441 -2760 6 18.5773 8.13014 37.5708 2.8796 34.5567 21.0854 -2761 4 19.1021 8.93687 37.8089 1.20854 -19.8484 -10.1251 -2762 4 17.9431 8.09722 38.288 -3.97249 -3.14491 3.87795 -2763 6 46.9308 30.3817 11.0144 7.20248 -9.32119 -46.6603 -2764 4 46.4987 30.7035 10.1833 6.25688 -3.94108 30.979 -2765 4 47.431 29.6318 10.6212 -6.26387 6.19468 23.2459 -2766 6 54.6355 13.051 30.6677 -0.631529 -12.3617 0.377161 -2767 4 54.9401 12.1973 31.0202 -4.70537 6.73717 3.83911 -2768 4 54.6706 13.679 31.4001 -0.542159 7.57402 -2.77471 -2769 6 32.2973 35.1412 27.9506 0.702746 7.41177 51.9011 -2770 4 32.3519 35.6753 28.7977 -4.11304 1.55554 -34.3644 -2771 4 32.0809 34.2722 28.2835 1.42742 -15.3938 2.35714 -2772 6 4.45353 25.396 31.7914 -28.2716 -32.1048 1.32297 -2773 4 5.00928 24.905 32.4172 3.79617 9.45861 3.32159 -2774 4 4.83781 26.2295 31.6234 26.2458 34.1175 0.407684 -2775 6 40.7781 38.1509 21.8521 -13.1408 -33.509 11.5706 -2776 4 40.6716 39.044 22.1698 7.33695 21.0707 -1.24628 -2777 4 41.4481 38.0623 21.1738 10.5508 14.8215 -9.14642 -2778 6 26.6931 9.85845 27.4042 -43.8759 24.145 24.882 -2779 4 26.9952 9.1619 26.8761 23.7363 -35.7414 -23.7206 -2780 4 25.7673 9.60487 27.6152 14.5566 8.07269 5.62533 -2781 6 53.3967 39.4485 11.7649 68.843 -10.0355 -14.0333 -2782 4 54.4148 39.3855 11.5456 -53.2103 8.20916 12.7106 -2783 4 53.105 40.2482 11.2866 -1.29569 -7.05369 14.3337 -2784 6 35.3292 21.4155 2.23587 15.106 -7.83484 -18.4876 -2785 4 34.912 20.5764 2.48744 -1.27765 6.93695 -0.309601 -2786 4 35.8084 21.2289 1.37944 -21.1629 3.53466 26.6292 -2787 6 4.14409 17.1449 33.9131 -16.1644 -22.9901 22.0601 -2788 4 4.14131 16.4411 34.6063 8.69636 10.7601 -14.4963 -2789 4 3.20404 17.192 33.6728 6.06844 1.20479 -9.99864 -2790 6 24.1486 16.1886 14.6752 2.90394 -28.6462 -21.9437 -2791 4 24.2343 17.059 15.0346 0.494679 15.8947 1.83084 -2792 4 23.7735 16.3203 13.7888 -2.47926 -0.947779 4.85435 -2793 6 43.1303 2.83022 26.0988 7.42094 18.4339 -15.1049 -2794 4 42.3152 3.21229 26.4285 -6.54764 -1.84254 4.96768 -2795 4 43.2129 3.23454 25.2082 4.91034 -11.1878 11.8147 -2796 6 40.68 12.1827 1.56051 12.2683 5.96873 16.2718 -2797 4 41.5968 12.2158 1.84207 12.0551 -6.37233 -9.83141 -2798 4 40.2741 12.5174 2.36876 -21.9125 -2.35909 -10.0625 -2799 6 47.3781 8.09655 26.7608 82.0606 26.064 -7.54845 -2800 4 46.666 7.67998 26.3919 -67.6244 -33.3987 -26.4118 -2801 4 48.0445 8.01522 26.0221 -12.6559 5.80771 33.8866 -2802 6 35.8947 30.7223 38.5098 17.2216 52.6179 -38.6143 -2803 4 35.6523 29.9703 39.0072 10.7188 -28.2359 27.6772 -2804 4 36.8587 31.0199 38.5623 -37.3038 -25.1724 3.03639 -2805 6 51.3054 23.2176 32.4969 -40.2617 11.1267 -4.72183 -2806 4 51.571 23.9803 31.9692 8.10126 9.10595 3.65824 -2807 4 52.0738 22.7076 32.6523 27.5758 -14.8312 4.00399 -2808 6 30.6066 4.44965 39.6625 0.615077 -4.04577 -5.4494 -2809 4 30.9728 3.64581 40.0124 3.38991 -22.1323 -0.234101 -2810 4 30.7691 5.02119 40.3987 0.467535 29.3806 6.08815 -2811 6 35.2584 29.6988 2.86074 -18.8762 -20.4699 -30.2285 -2812 4 35.7444 29.7805 2.00551 -3.31399 -2.84145 17.507 -2813 4 34.478 29.0852 2.62897 29.9452 30.586 13.9144 -2814 6 50.3064 26.1399 9.38994 -11.2342 14.6262 -3.47403 -2815 4 49.9288 26.8854 8.86032 11.0364 -25.2497 6.23881 -2816 4 49.6695 25.4035 9.37359 7.94529 9.32604 -3.86417 -2817 6 50.1026 36.8163 26.4125 -14.5138 -5.51826 -11.285 -2818 4 49.5888 36.0167 26.6617 3.79204 13.187 5.56915 -2819 4 50.2319 37.3727 27.1922 -3.20057 1.11223 6.19844 -2820 6 40.3045 23.9511 38.5442 56.3682 27.7758 -3.16545 -2821 4 40.8125 24.7624 38.7991 -6.5383 -29.3065 -12.768 -2822 4 39.4568 24.2221 38.8139 -44.6373 -1.162 12.0349 -2823 6 24.9504 10.7612 30.6561 23.3702 -4.90777 36.4738 -2824 4 25.6234 10.7245 31.4083 -25.7901 9.07318 -40.0098 -2825 4 24.9126 11.6687 30.2959 1.4184 -10.5997 2.42613 -2826 6 5.89627 1.02238 5.41014 -10.9637 -3.10309 -8.95081 -2827 4 5.14436 0.409378 5.47088 11.7326 -0.810065 6.31118 -2828 4 6.70289 0.529043 5.60145 -0.696658 -1.4992 -0.407558 -2829 6 44.282 29.3718 26.2736 69.4655 -24.0165 25.5627 -2830 4 43.5561 29.7046 25.8233 -49.9183 11.7173 -34.3685 -2831 4 44.8903 28.8623 25.6892 -19.9675 5.54095 9.74148 -2832 6 25.3119 10.1784 6.67292 -15.7736 -23.3412 -3.06725 -2833 4 25.6521 11.0537 6.64576 10.6351 24.7362 -4.37451 -2834 4 25.4625 9.79379 5.79618 6.21987 0.326131 1.26241 -2835 6 13.3514 28.0662 2.56722 45.2358 13.6418 17.9819 -2836 4 12.4545 27.8107 2.56105 -32.9681 -11.4511 -11.8173 -2837 4 13.8041 27.7134 1.79344 -6.10921 -0.687749 -0.120894 -2838 6 6.44709 40.2351 18.0254 21.2427 9.30891 -1.39987 -2839 4 6.966 39.4726 17.7533 0.137807 -7.29984 6.20872 -2840 4 5.59682 40.0602 17.6456 -22.1821 0.316247 -4.7234 -2841 6 47.7944 13.5061 2.01255 -17.6425 -30.8617 30.605 -2842 4 48.2016 12.6358 2.19438 -7.04124 7.54818 -3.24284 -2843 4 48.4122 13.9735 1.50015 28.8905 20.8749 -24.4455 -2844 6 13.5944 20.2974 2.4458 20.0315 11.2691 18.6487 -2845 4 13.7883 19.6075 3.10831 1.39134 9.87367 -8.40212 -2846 4 13.0064 19.8713 1.85297 -21.5499 -10.3053 -19.2062 -2847 6 15.2336 0.850818 36.6661 8.37652 40.6516 -23.9146 -2848 4 15.3117 1.46746 37.4264 -6.40063 -24.0213 -7.24367 -2849 4 15.3514 1.51981 35.909 -6.71396 -40.605 26.1829 -2850 6 33.5971 35.2491 15.0847 71.6425 -10.6997 11.4711 -2851 4 33.8969 35.3297 16.0058 -20.0956 -0.49545 -2.4869 -2852 4 34.508 35.0431 14.6807 -47.978 4.31732 -2.67502 -2853 6 21.7981 9.23698 0.429299 24.0185 -25.5324 29.6504 -2854 4 22.426 9.07175 41.6424 8.6426 -4.20457 -11.04 -2855 4 21.1884 9.81045 0.032847 -35.1273 25.1593 -17.3244 -2856 6 38.1453 27.4709 3.0333 47.9463 -55.6761 10.6859 -2857 4 37.7532 27.3037 2.19157 -17.0599 1.14667 -24.2168 -2858 4 37.8405 28.2288 3.44687 -27.291 50.0057 16.1216 -2859 6 38.8714 27.215 11.7709 41.141 -36.7506 -15.3879 -2860 4 38.9285 26.3434 12.2193 -14.3396 10.7389 0.963039 -2861 4 39.5886 27.0941 11.0922 -22.6073 11.6268 16.0227 -2862 6 29.8734 41.5737 28.6987 15.2279 35.2113 -10.5566 -2863 4 28.9552 41.3162 28.7047 -13.1778 -5.77603 2.88395 -2864 4 29.9141 0.263017 27.9132 -0.896253 -12.9147 16.3719 -2865 6 34.03 8.70777 38.0687 38.5763 27.6628 16.1728 -2866 4 34.8607 8.18924 38.1985 -14.88 11.0383 -8.6682 -2867 4 33.3419 8.15213 37.7593 -24.3719 -27.4308 -8.08559 -2868 6 38.8091 27.3495 30.6738 6.32435 -21.1782 -4.52762 -2869 4 38.5154 26.4386 30.4378 -1.34454 21.7952 1.35616 -2870 4 38.3686 27.5808 31.4849 -11.9448 1.82739 7.69603 -2871 6 41.6473 17.269 36.3639 7.45605 15.5752 1.52238 -2872 4 41.3137 17.162 35.483 -10.4634 0.342165 -15.0979 -2873 4 41.7169 16.3923 36.7151 5.72978 -18.5967 8.16978 -2874 6 30.7243 26.977 35.2074 -15.5404 -28.2563 -3.1326 -2875 4 31.3953 27.4345 34.7177 18.5093 15.4635 -5.31058 -2876 4 30.2206 27.5565 35.766 -0.690558 20.2492 9.56945 -2877 6 47.5414 4.09198 27.2867 -2.42911 13.6608 18.2544 -2878 4 46.636 4.37242 27.4325 -10.4037 -2.52064 9.15115 -2879 4 47.5606 3.99786 26.3497 6.55325 -3.96267 -23.0579 -2880 6 20.946 8.39203 7.27322 -27.8597 -45.7319 -0.818331 -2881 4 20.9365 8.74812 8.15774 -0.207227 20.4039 13.5637 -2882 4 21.4094 8.93893 6.67191 21.7448 31.5979 -18.7028 -2883 6 36.8544 13.691 0.855516 -6.96494 -6.58957 -4.7536 -2884 4 37.3845 13.474 1.605 15.5913 2.53244 29.7992 -2885 4 37.0002 12.9032 0.328977 -4.78774 -2.28905 -12.5933 -2886 6 28.5904 20.2994 26.4544 16.2695 -3.42806 -15.5352 -2887 4 28.4835 19.402 26.1318 -1.12761 -3.3858 2.90642 -2888 4 27.7814 20.5406 26.8733 -22.93 6.76513 15.2817 -2889 6 51.6079 16.8571 33.5121 -4.50033 -4.43314 5.93611 -2890 4 51.6159 16.0837 34.101 -3.91985 -0.958274 -7.09147 -2891 4 50.9053 16.6875 32.8669 7.1497 -2.58651 -2.16023 -2892 6 16.2715 32.0073 37.6936 -41.8913 -21.032 -18.7972 -2893 4 16.4093 31.405 38.4555 0.0363557 12.0183 -19.687 -2894 4 15.4977 31.6058 37.1477 38.3353 16.8511 22.6146 -2895 6 14.3407 25.877 13.2155 1.26588 11.3619 -17.2713 -2896 4 13.5013 26.0279 13.6901 5.40221 7.27027 -0.947788 -2897 4 14.4551 26.5608 12.5093 -9.57117 -0.277473 20.5459 -2898 6 54.9749 28.8768 3.30374 1.15612 -53.5629 -1.59986 -2899 4 54.8083 28.9028 2.3467 2.04661 0.129141 5.0455 -2900 4 0.26744 27.9124 3.48546 -12.4506 41.1861 -2.95604 -2901 6 17.22 5.15598 2.57931 -12.7888 -35.846 -9.7104 -2902 4 17.8674 4.52191 2.91459 -1.87097 -9.90488 -4.08214 -2903 4 17.421 5.9071 3.09191 1.36943 25.6696 10.0797 -2904 6 50.6995 33.0507 10.3154 6.59719 15.9916 42.5002 -2905 4 50.6222 33.8517 9.79386 -1.28667 2.08485 -11.8542 -2906 4 50.7575 32.2667 9.79209 -3.80283 -15.7636 -22.9095 -2907 6 28.8826 19.8405 32.3742 18.5732 17.2051 -15.397 -2908 4 29.8373 20.0763 32.2 -31.4986 -11.6613 7.66973 -2909 4 28.4094 20.6578 32.1253 1.55933 -8.77069 7.582 -2910 6 22.4307 12.8248 23.2991 -20.6917 10.5217 33.6658 -2911 4 22.5556 12.3422 24.1574 -2.40655 13.6672 -16.3005 -2912 4 21.7108 13.488 23.4947 18.3613 -16.8762 -11.246 -2913 6 54.7763 15.5394 8.86893 2.10476 3.1215 13.1486 -2914 4 0.465115 15.309 9.51431 10.762 -2.70861 -3.02895 -2915 4 53.9989 15.1653 9.30174 -3.31272 -0.629746 -12.248 -2916 6 10.4518 19.2967 26.1704 43.67 -11.1159 60.7251 -2917 4 11.2502 18.7163 26.2348 -22.5321 13.8961 -6.48776 -2918 4 10.166 19.2541 25.3007 -24.1973 -3.18459 -58.4054 -2919 6 38.6496 20.2998 35.2325 20.2193 -0.813999 -8.63065 -2920 4 39.5955 20.3672 34.9603 -17.6326 -1.16496 9.70871 -2921 4 38.5782 19.6093 35.9099 2.97533 6.68842 -2.65526 -2922 6 17.4906 18.0487 15.2499 -10.3405 45.0299 20.0184 -2923 4 17.3837 17.5615 14.4531 -8.22833 -15.0257 -32.2828 -2924 4 17.2318 18.9864 14.9797 13.5676 -28.3997 10.204 -2925 6 29.6331 0.960567 26.2796 -25.6031 -26.3316 -72.4206 -2926 4 29.3216 1.74647 25.7973 3.40072 6.61544 23.4347 -2927 4 29.2407 0.266373 25.6265 23.6279 16.4272 47.4057 -2928 6 30.4665 12.6849 28.2971 -10.7965 -27.9245 1.17671 -2929 4 29.8272 13.0822 27.7097 -1.40549 16.7134 -9.61387 -2930 4 30.1324 11.7665 28.3519 9.60572 9.94425 5.65357 -2931 6 36.6695 22.1225 33.3577 39.6017 -11.6369 -25.7224 -2932 4 37.5338 21.6663 33.4931 -10.4393 24.3252 -8.31461 -2933 4 36.1732 21.6976 34.0074 -34.1256 -9.27026 38.9845 -2934 6 34.8672 22.4666 14.3113 -12.0535 -16.0605 -66.2467 -2935 4 34.0349 22.4515 14.7407 -19.1997 11.5289 38.0952 -2936 4 34.5417 22.174 13.4128 25.6484 2.69091 24.3313 -2937 6 15.5262 9.60919 7.44527 49.3682 -27.3699 -19.0187 -2938 4 16.547 9.52246 7.26069 -54.7763 6.57045 5.33777 -2939 4 15.1277 8.71762 7.26288 7.76902 16.5773 17.8238 -2940 6 21.8158 28.0339 19.8054 -4.91607 2.79332 -16.2053 -2941 4 21.8614 28.4614 20.6522 -2.04715 7.82991 15.4338 -2942 4 20.8734 27.9328 19.6183 -0.9528 -10.4666 6.26348 -2943 6 34.5348 24.4247 2.43569 30.4222 -68.2311 14.7367 -2944 4 34.4753 23.4054 2.32054 1.69344 45.6403 0.121788 -2945 4 35.3397 24.4934 3.03523 -29.9154 15.8849 -16.545 -2946 6 12.599 20.9348 33.4989 -13.8827 -5.0407 19.8786 -2947 4 11.7591 20.6911 33.9854 14.8004 1.51093 -27.4282 -2948 4 12.4712 20.9089 32.5331 -6.4324 -2.96843 13.903 -2949 6 45.7737 31.1538 8.70434 -2.26925 11.3362 1.64289 -2950 4 45.9542 32.0869 8.96415 -8.39554 -11.7705 -15.6468 -2951 4 44.8313 30.9442 8.82297 5.93432 7.3758 2.64979 -2952 6 15.4817 22.5529 30.1787 5.69125 -30.6905 2.54506 -2953 4 16.2669 22.9885 30.4865 5.73919 23.8488 1.47991 -2954 4 15.7828 21.6299 30.2043 -15.5749 7.04719 -4.74998 -2955 6 39.7421 17.1743 38.4094 21.5551 17.0277 -9.47446 -2956 4 39.5031 16.7163 37.59 -3.21419 -6.16335 13.1695 -2957 4 40.5012 17.7258 38.123 -12.3818 -10.233 9.13463 -2958 6 13.9944 24.6739 0.675362 16.6213 17.4065 1.77653 -2959 4 14.3534 24.6315 1.57006 -7.52322 -5.04497 4.60086 -2960 4 14.2363 25.5684 0.403337 7.11699 -3.23043 -4.31609 -2961 6 31.5223 19.5616 3.57151 -53.5885 6.24325 20.3398 -2962 4 30.9852 19.2876 4.35912 8.49606 10.2921 -25.2864 -2963 4 32.3806 19.3906 3.88708 44.0272 -8.41539 -5.41474 -2964 6 36.1052 25.07 19.4414 -58.1964 5.4792 30.944 -2965 4 37.0178 24.9674 19.4291 53.7837 8.57858 1.17104 -2966 4 35.8724 24.6048 18.6565 -11.4284 -6.26335 -25.0938 -2967 6 51.6856 17.6883 14.8068 3.37141 18.4291 36.2611 -2968 4 51.7159 18.5692 15.274 12.631 -26.1695 -13.2311 -2969 4 51.0805 17.8845 14.1157 -15.036 4.32684 -29.7308 -2970 6 37.7054 27.4905 38.1961 21.1085 51.9404 -4.50496 -2971 4 37.7442 26.8536 37.5026 -5.7586 -24.9449 -15.2301 -2972 4 38.1753 28.2651 37.7886 -14.569 -23.1779 14.5181 -2973 6 34.7911 13.8542 30.7834 63.814 8.34946 -38.9004 -2974 4 35.1479 14.6416 31.2053 -8.52888 3.60926 11.6955 -2975 4 33.9958 13.5796 31.1473 -54.5977 -12.3598 32.1143 -2976 6 19.6332 37.3754 39.9698 -24.3625 -2.8653 -8.02349 -2977 4 20.5737 37.5051 40.1221 10.6449 -2.37562 -1.97502 -2978 4 19.476 36.9037 39.1231 9.83703 4.21653 7.37417 -2979 6 40.9393 34.0697 21.4586 2.1394 -11.0927 -27.2527 -2980 4 41.1855 34.0244 22.3739 -0.995015 -5.02364 12.6588 -2981 4 40.8269 33.1391 21.1809 -5.56645 12.5591 1.05516 -2982 6 32.9542 27.2131 26.5676 21.8236 31.3611 42.3808 -2983 4 33.7455 27.7378 26.9411 -38.3522 -19.3744 -9.62352 -2984 4 33.2804 26.8388 25.7801 14.7034 -8.88898 -37.5519 -2985 6 24.4045 18.6625 15.6046 15.6323 5.3487 0.0952382 -2986 4 23.6496 19.2317 15.7207 -14.8084 -1.4602 1.41466 -2987 4 24.5649 18.2576 16.462 -0.219489 -3.50303 9.55317 -2988 6 29.9663 1.63299 9.06934 -19.1782 58.0281 -13.4952 -2989 4 30.0652 0.728361 9.20589 6.15764 -53.3299 8.23098 -2990 4 29.142 1.69178 8.53744 13.8409 -0.846673 8.85197 -2991 6 31.4884 20.0987 7.87879 28.0207 -11.7442 -56.0977 -2992 4 31.929 19.6692 7.07379 -7.62771 20.3934 38.6055 -2993 4 30.8102 19.4535 8.0257 -16.4635 -8.90407 20.6678 -2994 6 35.0404 3.79156 33.2694 -1.07326 -4.91424 22.8916 -2995 4 34.2545 4.23611 32.9039 10.815 -2.65177 -4.17514 -2996 4 34.969 3.91026 34.2418 -2.62674 -1.77539 -18.1187 -2997 6 43.9504 7.96546 12.9857 17.1829 -21.9111 0.113786 -2998 4 43.3325 7.29581 13.3448 8.44862 12.3123 -3.96012 -2999 4 43.4563 8.73573 12.7333 -15.1408 11.4953 0.0339333 -3000 6 44.1156 32.6759 16.9403 5.31814 23.9263 4.94933 -3001 4 44.7028 33.4557 16.8081 -6.11209 -18.3833 -3.28173 -3002 4 44.1603 32.5425 17.8901 -3.26507 -3.06823 6.73624 -3003 6 40.6044 27.171 19.0399 5.35236 -7.54795 -39.8413 -3004 4 39.9756 26.4797 18.7399 3.73803 11.5815 8.49028 -3005 4 41.0398 27.5246 18.2027 -12.4172 -8.32437 32.3474 -3006 6 46.047 23.2024 29.047 17.2683 37.2743 26.3298 -3007 4 46.6657 23.8797 29.4684 -18.5589 -27.346 -17.4569 -3008 4 46.486 22.3548 28.9238 8.34839 -6.65718 2.80441 -3009 6 42.6215 30.6103 18.862 -5.01232 -15.325 -26.4249 -3010 4 43.5272 30.7476 19.0895 18.324 11.0008 12.4889 -3011 4 42.704 29.9429 18.1625 -17.0641 3.12823 2.85026 -3012 6 36.1251 10.8932 23.2678 23.6581 36.1082 4.04534 -3013 4 35.2523 11.2865 23.1129 -2.80799 -1.69562 1.02392 -3014 4 36.6983 11.6913 23.4963 -28.2294 -33.6871 -7.78786 -3015 6 13.7386 31.5223 15.7271 -4.49361 3.73805 -16.8081 -3016 4 14.6779 31.7192 15.7387 3.94655 -1.56597 5.72926 -3017 4 13.381 32.0318 14.979 -1.5565 -4.12563 8.0657 -3018 6 33.1703 41.4275 27.7797 10.5813 -15.702 68.4674 -3019 4 32.9714 0.101499 27.0951 -7.66273 31.9341 -41.1766 -3020 4 33.2579 0.043937 28.6255 4.60937 -17.5422 -27.6682 -3021 6 32.9019 22.9042 31.4856 -22.5274 37.748 -5.90861 -3022 4 32.2895 23.1741 30.7829 6.44322 -22.1433 -13.1277 -3023 4 32.7242 23.6662 32.0583 13.0029 -8.58894 11.8377 -3024 6 27.6559 16.8629 6.38841 0.759442 -6.33883 29.8789 -3025 4 27.8611 17.2083 5.54221 8.69809 17.4791 -25.8043 -3026 4 26.8031 16.4594 6.24591 -13.957 -6.38022 2.63501 -3027 6 47.2651 11.6173 26.0576 8.33461 35.0159 47.6166 -3028 4 47.0912 11.6838 27.0214 -5.10661 -22.4254 -22.6877 -3029 4 47.7461 12.4597 25.9756 -3.10554 -9.06377 -24.8427 -3030 6 27.5595 7.06242 7.64189 36.0057 -29.1625 5.70238 -3031 4 26.7484 7.49683 7.83093 -25.0876 11.7282 17.2448 -3032 4 28.0841 6.86482 8.45622 -15.7481 15.6684 -17.1357 -3033 6 39.8009 9.06823 11.973 -19.1879 4.0297 -12.8881 -3034 4 39.4826 9.27056 11.0665 6.39012 -4.37616 15.6201 -3035 4 38.9894 9.1094 12.5089 2.28999 7.64442 -1.09803 -3036 6 18.1977 33.4656 36.103 -47.2434 1.22325 7.58723 -3037 4 17.6693 33.9565 35.4324 13.0563 -6.22307 9.58411 -3038 4 17.491 33.069 36.7104 31.5801 5.82297 -20.8408 -3039 6 37.1917 26.5507 0.720984 -4.45309 15.6177 5.32368 -3040 4 37.3846 25.6567 0.44907 -1.85313 -8.64798 -1.56679 -3041 4 36.2207 26.6114 0.739208 8.96605 -1.46339 -9.13916 -3042 6 44.1887 19.6251 36.8885 40.0452 -6.58607 -3.19327 -3043 4 45.0262 19.1233 36.6753 -25.2412 9.90919 11.1214 -3044 4 44.4881 20.5478 36.9825 -7.95545 -4.32402 -1.12283 -3045 6 27.7744 6.35339 35.6933 13.1235 -8.00403 1.40836 -3046 4 27.1655 6.97567 35.3121 -8.4989 9.93248 -6.95364 -3047 4 27.2748 5.53908 35.7675 0.865215 -2.72076 5.22838 -3048 6 34.7673 16.4826 20.8897 25.0208 -26.1622 5.09639 -3049 4 35.5801 15.8751 20.9364 -40.3091 28.8833 0.638889 -3050 4 34.1629 16.1653 21.5964 8.34467 8.45669 -12.6288 -3051 6 39.0349 20.9701 40.4369 -35.0548 -83.2732 -20.3586 -3052 4 38.7355 20.0763 40.8679 21.616 52.9309 -20.1646 -3053 4 39.3277 21.5521 41.0958 10.956 28.6509 41.127 -3054 6 10.8075 27.9275 1.66251 45.0798 11.5101 -39.3642 -3055 4 10.1207 27.6506 2.20454 -46.3214 -11.9312 37.0665 -3056 4 10.864 28.8887 1.77269 -0.956148 -2.75571 -0.87801 -3057 6 47.0235 23.1304 13.2457 -34.1648 -14.46 -9.62139 -3058 4 47.6809 23.5773 12.718 7.19949 7.22116 -4.18429 -3059 4 46.2703 22.9258 12.6132 27.3011 3.73645 28.26 -3060 6 34.5862 28.4037 10.6629 -11.4192 -4.75939 1.42695 -3061 4 34.4799 27.7252 11.3319 -5.35328 -3.69815 4.40234 -3062 4 35.5403 28.4214 10.6073 9.29856 11.2923 -14.2157 -3063 6 3.3474 17.5828 14.2796 -19.4871 24.8451 -12.2706 -3064 4 3.54237 16.6973 14.5399 7.15819 -24.2504 13.4427 -3065 4 3.84281 18.1577 14.8755 9.98901 -5.90389 -1.38432 -3066 6 27.7213 11.5993 7.52196 5.39723 39.0715 -5.17771 -3067 4 27.6701 12.604 7.61024 4.43832 -37.6789 -1.1729 -3068 4 27.2296 11.2227 8.25132 -2.72363 -3.1191 8.53492 -3069 6 41.4314 28.3382 9.01837 19.0589 -0.973961 -18.7609 -3070 4 40.8555 28.7961 9.62238 -6.75468 20.1798 6.66135 -3071 4 41.7073 28.957 8.28743 -10.8025 -14.2077 17.7393 -3072 6 42.0854 4.7797 8.18851 -21.257 14.5957 -52.3899 -3073 4 42.0432 5.70949 7.81908 14.9695 -22.9802 20.9203 -3074 4 41.8649 4.22501 7.38905 12.6142 12.8494 32.4876 -3075 6 28.4682 8.6325 40.3242 -61.7219 6.47809 -5.55454 -3076 4 27.7379 8.57122 40.9835 27.869 -4.13123 -2.00049 -3077 4 27.8882 8.69791 39.5144 34.8971 -1.31486 9.68376 -3078 6 0.711352 18.2475 15.2828 -1.03732 14.0577 26.4962 -3079 4 1.6037 18.2498 14.9622 18.0256 -6.96047 -13.9963 -3080 4 0.201613 17.7329 14.6701 -10.6254 -13.4061 -11.9404 -3081 6 7.11345 16.2289 40.4432 8.45023 -35.9074 47.1296 -3082 4 7.17312 15.3057 40.7986 -0.221024 11.0765 -27.8146 -3083 4 7.22051 16.6703 41.3088 -5.23596 22.4775 -22.5048 -3084 6 41.0858 8.62552 20.9048 11.0684 -11.3616 26.0286 -3085 4 40.3918 8.42716 20.2762 -10.0062 9.73992 -12.3328 -3086 4 41.3944 9.53753 20.8124 -4.81268 6.06535 -10.7329 -3087 6 31.7073 7.42286 37.542 -14.8479 -9.90339 6.69006 -3088 4 31.4959 7.12404 36.6506 2.47263 0.526998 -6.01676 -3089 4 30.9335 7.11441 38.0458 14.4773 7.59586 -0.291785 -3090 6 40.7266 11.6476 25.425 -35.4896 13.4329 -16.1803 -3091 4 40.7395 12.5913 25.6925 9.9362 -18.5419 -7.18222 -3092 4 41.5423 11.2236 25.6435 22.7694 -4.71413 12.394 -3093 6 29.8665 30.1579 6.66307 26.6562 -4.16721 8.5177 -3094 4 30.5555 30.7343 6.31583 -2.18777 1.73834 -10.5199 -3095 4 30.3573 29.3259 6.76714 -13.2281 -1.59651 -6.45815 -3096 6 40.8439 24.5837 5.68012 15.8615 33.1962 -4.14396 -3097 4 41.3457 25.4223 5.9023 -8.27611 -29.5734 -8.52614 -3098 4 40.1119 24.5659 6.27901 -12.3156 -1.80355 11.8721 -3099 6 34.3917 9.09675 20.4219 17.6262 -1.15942 17.9162 -3100 4 33.57 9.43601 20.7884 -5.86563 4.88571 -3.34935 -3101 4 34.2167 8.80099 19.5352 -13.2656 -6.03918 -15.2606 -3102 6 18.2311 33.5548 26.5354 9.60899 -55.578 -54.4315 -3103 4 19.159 33.2107 26.4405 -23.3884 24.4218 8.45675 -3104 4 18.1621 34.044 27.3085 3.33799 34.4716 53.9641 -3105 6 28.9072 17.4193 26.7965 8.90265 -1.34032 10.3526 -3106 4 28.3267 16.8801 26.2506 -9.53448 5.67773 -5.57268 -3107 4 28.3756 17.7646 27.5432 9.63981 -8.23286 -8.72686 -3108 6 50.4255 35.5446 18.192 14.112 9.6817 -2.74072 -3109 4 50.5661 35.3326 17.2487 -8.6314 -7.47676 15.7559 -3110 4 50.5766 34.7477 18.7329 -11.9848 3.75846 -10.2286 -3111 6 2.99463 21.5653 31.4474 1.68271 -21.0005 -22.757 -3112 4 3.33698 22.262 30.8385 -11.1525 -11.1618 12.076 -3113 4 2.83901 20.7479 30.8788 5.9339 29.1288 19.4027 -3114 6 36.1811 18.7457 8.60665 26.0746 50.7707 2.54435 -3115 4 36.1969 17.9289 9.04749 -6.79937 -48.2248 12.3681 -3116 4 35.6147 18.7828 7.85483 -18.853 -7.00319 -22.0811 -3117 6 20.2934 6.48366 33.7248 -33.7925 -21.1439 9.08779 -3118 4 19.8228 6.33509 34.5702 11.9648 11.0481 1.53323 -3119 4 19.9109 5.73333 33.234 17.8653 6.32962 -8.93867 -3120 6 14.0016 30.5326 6.65439 -2.06342 0.226434 14.1624 -3121 4 14.6658 31.0189 7.18657 -8.4774 -5.82658 -13.2159 -3122 4 13.1556 30.6664 7.11082 5.19683 1.19435 -6.65694 -3123 6 36.2738 16.4523 35.7634 28.7444 28.7466 -1.25628 -3124 4 37.2529 16.3082 35.8444 -30.8138 -2.80693 3.80535 -3125 4 36.1869 17.4417 35.6433 -1.25715 -33.4762 0.326736 -3126 6 45.8255 37.6646 9.68707 16.0609 -41.2042 -13.6418 -3127 4 45.4852 38.2919 10.2717 -20.4348 34.8513 25.7777 -3128 4 46.231 37.0083 10.2774 7.06244 2.74597 -12.4723 -3129 6 47.4229 17.9968 27.6368 -1.79372 -57.0164 -4.60636 -3130 4 47.566 17.432 26.8065 -4.8869 24.4286 27.8294 -3131 4 47.3631 17.3546 28.4089 6.87022 22.2846 -25.0829 -3132 6 25.9574 18.2976 0.964228 23.0858 -4.77958 -10.3735 -3133 4 26.3734 18.9022 1.60725 -19.9671 -4.02324 -2.33442 -3134 4 24.9961 18.2982 0.948557 -9.32218 6.60301 10.8105 -3135 6 27.3657 22.4026 4.28337 1.04907 -15.9856 -17.2206 -3136 4 27.2658 23.3197 4.47064 2.83879 26.7243 10.1579 -3137 4 27.3462 22.4079 3.3181 -1.05974 -10.8362 7.50108 -3138 6 3.39902 3.84297 27.6033 -32.797 -16.937 8.3321 -3139 4 3.87422 4.64571 27.4715 26.6916 15.5682 -1.1402 -3140 4 3.96055 3.06079 27.6076 7.92228 2.5358 -5.38712 -3141 6 45.3564 27.6573 28.835 13.8657 -6.64535 19.4164 -3142 4 44.592 27.1099 28.6295 -10.1072 2.65107 -0.516215 -3143 4 45.3903 28.3299 28.161 -2.22034 5.33578 -9.67936 -3144 6 28.3928 32.384 16.2149 35.1766 -7.36337 1.61596 -3145 4 29.2284 32.2059 15.7054 -23.0821 5.0916 11.0276 -3146 4 28.7076 32.6186 17.1078 -8.03404 1.42552 -9.59962 -3147 6 9.90485 33.8293 13.0286 10.5996 -3.42126 36.647 -3148 4 9.63365 33.2371 13.7754 2.50037 15.8816 -14.8106 -3149 4 9.32864 33.6931 12.2897 -16.1444 -6.90665 -19.0975 -3150 6 38.3335 26.6343 14.9205 -0.551684 -24.4487 3.86314 -3151 4 38.658 25.7334 15.149 1.53578 20.736 -5.06851 -3152 4 37.3858 26.5974 15.0972 1.00556 4.30146 -0.183996 -3153 6 31.3571 16.3836 4.2445 -16.7299 -18.7641 16.8138 -3154 4 30.5501 15.9079 4.56795 14.9054 8.61271 -6.80276 -3155 4 31.2311 16.4593 3.29715 -1.72501 9.16645 -9.12782 -3156 6 6.17482 3.39637 6.55833 17.6941 29.4886 56.031 -3157 4 6.41103 3.08651 7.49149 -7.06328 10.7723 -41.2395 -3158 4 5.9143 2.63963 6.07247 -2.51266 -29.5732 -15.1374 -3159 6 42.5954 13 5.61529 2.6815 -10.2341 6.00586 -3160 4 42.2228 13.83 5.89445 -1.70762 9.74234 -1.3058 -3161 4 43.4476 12.9425 6.06763 3.18432 -3.38396 -9.63491 -3162 6 41.0469 31.4032 33.8032 -2.41258 31.7421 -2.74763 -3163 4 40.7074 31.3974 34.7214 7.44932 1.1292 -16.4995 -3164 4 41.1575 32.3688 33.5162 -1.31614 -41.8694 16.6901 -3165 6 52.8576 12.0626 26.2641 9.5895 -24.4248 -55.9842 -3166 4 52.4684 12.727 26.7939 -19.7064 26.0739 18.5009 -3167 4 52.6066 12.2568 25.3043 12.3637 -4.77707 33.6793 -3168 6 39.2086 4.29542 29.0724 8.4008 5.1904 -7.5125 -3169 4 38.4444 4.85752 29.2861 11.0986 -5.7068 1.32154 -3170 4 39.9986 4.64958 29.5231 -9.05665 -5.78587 -2.57989 -3171 6 3.65769 27.0104 11.285 -33.2394 -3.70913 -3.8751 -3172 4 4.59992 26.8829 11.3514 17.6792 2.33561 -5.11125 -3173 4 3.4519 27.7953 10.7423 10.2361 0.60791 3.91121 -3174 6 41.5441 29.6402 25.2654 2.79284 -4.6021 22.0238 -3175 4 41.8464 29.7038 24.3667 4.04268 2.71218 -16.2057 -3176 4 40.7127 30.1073 25.3399 -6.11251 5.69311 -9.79107 -3177 6 50.4754 27.4974 30.671 -6.87832 -12.1873 7.27551 -3178 4 50.0778 27.1279 31.4799 3.22248 2.82006 -4.01445 -3179 4 49.7824 27.9982 30.2275 0.0461655 4.73 -3.38362 -3180 6 32.7876 33.6322 41.7537 -8.7541 -8.89692 -39.0089 -3181 4 33.1671 32.7559 41.8028 5.47994 -11.5785 5.15438 -3182 4 32.9083 34.029 0.675063 4.83491 15.974 33.6037 -3183 6 5.9806 9.64323 7.93715 4.3965 6.41539 -15.2951 -3184 4 5.77829 9.93579 8.8312 0.6559 3.73469 4.68299 -3185 4 6.3228 10.4083 7.4265 1.56495 -8.59939 9.02132 -3186 6 52.7884 25.3949 27.7 -7.43266 -9.74322 -1.44878 -3187 4 52.93 26.351 27.8747 -0.851616 -24.8244 8.41831 -3188 4 52.9998 24.8518 28.4994 7.3809 16.2458 -18.9874 -3189 6 18.6796 23.2043 14.4609 8.49541 46.7244 28.1607 -3190 4 18.697 24.1166 14.872 -21.1178 -26.825 -16.729 -3191 4 19.5981 23.1771 14.2416 15.365 -21.3066 -15.3625 -3192 6 31.2857 9.07887 13.0786 26.2489 -54.2202 -11.3888 -3193 4 31.3193 8.20519 13.5416 -2.63874 16.5358 -10.154 -3194 4 30.7972 9.64602 13.6278 -24.9284 29.9413 31.6235 -3195 6 52.8163 16.833 29.9704 25.4684 -2.46115 -18.7711 -3196 4 53.1785 16.3479 29.2052 -11.8989 0.938692 6.7974 -3197 4 53.5445 17.4528 30.1342 -3.36222 3.81908 9.3955 -3198 6 13.4835 30.6533 11.9137 -46.9609 -12.8402 15.0292 -3199 4 12.8701 31.2475 12.4314 22.3442 -12.341 -15.3642 -3200 4 14.3315 31.0589 11.9363 20.4041 22.2607 2.0467 -3201 6 24.4145 24.6647 11.1793 -22.2983 -41.6602 -10.5575 -3202 4 25.2113 25.1208 11.3859 27.2622 9.38308 11.5927 -3203 4 24.6402 23.6908 11.0915 -11.4513 27.6962 10.6476 -3204 6 11.1203 26.798 5.92715 -0.288466 28.8994 -0.991584 -3205 4 11.4516 26.991 6.8143 4.21529 -7.59652 -0.673238 -3206 4 11.0194 27.7223 5.58288 -7.6649 -30.4822 0.0195949 -3207 6 12.0071 32.3096 4.57291 -4.86243 14.2275 -68.6847 -3208 4 11.7793 31.9281 3.63093 8.01684 14.4954 56.5286 -3209 4 12.2995 33.2463 4.37904 -4.11207 -26.5611 6.70158 -3210 6 6.4322 5.49281 30.4716 35.2368 -18.2726 5.22228 -3211 4 6.85856 6.3256 30.2181 -6.14256 4.86399 -3.96588 -3212 4 5.49729 5.53619 30.4137 -26.8093 16.306 -3.74387 -3213 6 38.1866 39.6 29.3849 -55.2477 -18.0227 -31.7741 -3214 4 37.4363 40.1798 29.0864 28.3626 1.3397 12.8196 -3215 4 37.8398 38.7214 29.0428 28.3274 26.4583 13.0641 -3216 6 52.5811 19.3636 5.41604 51.907 48.1011 -36.5249 -3217 4 52.4834 20.3242 5.17263 -20.1975 -32.0404 8.71389 -3218 4 53.4908 19.2453 4.99747 -31.6145 -20.6418 25.5541 -3219 6 18.3356 9.8205 21.0747 -17.6268 -29.6196 -17.636 -3220 4 17.8021 9.40634 20.3533 -1.88913 9.35392 27.897 -3221 4 19.0546 10.1733 20.5835 25.9839 20.5094 -7.72749 -3222 6 14.4924 41.1161 15.0432 10.1364 3.71296 -9.89663 -3223 4 15.2732 41.1462 15.6022 9.62288 -5.62086 4.10329 -3224 4 13.9031 41.7078 15.5102 -8.32301 1.75038 3.32266 -3225 6 35.9996 23.9069 26.7492 18.6837 -25.8156 -39.8793 -3226 4 35.9246 23.4421 27.5469 -8.45021 -0.659318 44.9575 -3227 4 36.3072 23.1381 26.2025 -8.08285 36.2837 5.17172 -3228 6 35.634 10.4286 26.2543 -16.0886 -36.8378 31.8954 -3229 4 36.0318 10.4196 25.4062 11.0324 6.64788 -31.8122 -3230 4 35.4344 9.46932 26.4326 4.10196 23.0818 -6.20158 -3231 6 45.3004 24.2842 20.2749 24.2383 10.4641 7.4623 -3232 4 45.3515 25.0535 19.6808 2.20237 -7.91345 -3.22769 -3233 4 44.5434 23.7522 20.0895 -20.4117 -5.11737 -13.922 -3234 6 15.8182 39.0515 24.2407 12.965 16.6456 0.954929 -3235 4 15.3741 39.8779 24.5544 7.5658 -17.411 -0.0196462 -3236 4 16.7724 39.3066 24.1247 -29.8541 -4.22386 6.92178 -3237 6 4.60659 25.9073 16.8122 1.83212 2.60998 -1.97709 -3238 4 5.31562 26.4095 17.2499 -5.00617 -6.2898 0.278133 -3239 4 3.79975 26.4302 16.9186 11.5163 2.87992 -0.585475 -3240 6 33.4767 9.9887 32.5701 -44.5277 -5.18869 -27.5725 -3241 4 34.322 10.1593 32.8843 54.6618 16.656 18.5178 -3242 4 33.0203 9.70843 33.3575 -8.70161 -12.0001 8.14623 -3243 6 22.9321 37.514 1.50284 -0.19108 -28.0604 17.8877 -3244 4 23.0149 38.2279 2.13297 1.92014 9.99004 7.14626 -3245 4 22.7552 36.7067 2.06858 1.19451 21.8657 -20.5647 -3246 6 39.1248 20.5474 25.4766 21.2332 -16.8391 26.0428 -3247 4 39.2186 21.3943 25.0643 2.22233 17.645 -5.02625 -3248 4 39.853 20.5019 26.1611 -16.83 0.667515 -19.8449 -3249 6 25.0699 25.071 37.6104 17.3941 16.9986 -26.7924 -3250 4 25.9994 25.4036 37.6322 -19.4928 -16.3283 1.07636 -3251 4 24.8822 24.8366 38.5108 -1.54859 -5.98321 18.8059 -3252 6 12.2108 35.7702 11.4211 -21.274 -0.450661 -24.3109 -3253 4 11.4942 36.1177 10.8268 17.2098 -2.57945 23.3101 -3254 4 12.7534 35.3113 10.7723 8.20233 4.40137 5.7707 -3255 6 42.0318 15.7212 20.1319 23.9789 -4.66934 -19.8056 -3256 4 42.573 15.4482 19.3354 -11.2719 11.6022 18.1956 -3257 4 42.3198 16.6222 20.3614 3.24172 -2.08619 -3.65764 -3258 6 53.203 25.4276 39.527 3.00787 -13.9161 6.63788 -3259 4 53.7641 25.8569 38.8977 9.18601 6.10619 -8.92001 -3260 4 52.4886 26.0297 39.6953 -12.4398 9.9207 3.51955 -3261 6 53.7999 21.7704 1.29423 13.4333 -6.07506 22.1965 -3262 4 54.6908 21.5389 0.969279 -9.57261 -3.1085 -1.99035 -3263 4 53.3016 22.2177 0.619486 -6.56312 6.61298 -22.2093 -3264 6 1.93757 22.4543 20.1748 -8.22485 -1.41006 19.3874 -3265 4 1.60089 23.2534 20.6505 8.04613 -19.7643 -7.74833 -3266 4 2.27012 21.8339 20.8623 2.42307 18.0741 -7.93574 -3267 6 41.1802 16.179 11.484 -8.24259 53.7733 14.6683 -3268 4 40.8475 15.3772 11.8508 -2.32532 -30.9762 7.10209 -3269 4 40.6167 16.8825 11.9353 16.6943 -22.3779 -21.294 -3270 6 17.1967 38.6113 9.60334 5.35995 -1.86267 -8.12923 -3271 4 17.7852 38.6361 10.3521 13.641 -0.452934 12.0217 -3272 4 16.3282 38.6029 9.98982 -18.6262 -0.708432 10.1602 -3273 6 33.1969 12.9538 38.5484 12.352 25.5713 -8.86638 -3274 4 33.6486 13.824 38.4674 -8.05485 -18.2555 -5.8969 -3275 4 33.0335 12.8861 39.4897 4.37007 -7.66636 -4.23751 -3276 6 24.7228 21.6957 39.9776 0.331302 -26.4697 -8.75647 -3277 4 24.5832 21.6143 39.0045 0.235774 0.581704 12.5709 -3278 4 25.2663 20.9218 40.2505 -4.0265 10.6546 -4.86064 -3279 6 13.577 15.5497 27.3411 27.7809 44.9786 27.5516 -3280 4 13.196 16.0821 28.0648 5.30872 -0.0493108 -10.0398 -3281 4 12.9031 14.935 27.2057 -29.8548 -39.4113 -11.0219 -3282 6 24.6863 18.7248 9.26482 -8.80414 -2.51529 14.0236 -3283 4 25.3563 19.2311 8.7609 -6.6335 -0.338001 12.1858 -3284 4 24.3761 19.0911 10.1338 17.243 1.91927 -22.7003 -3285 6 10.9743 8.21046 0.042398 -18.7759 13.8117 62.0104 -3286 4 10.3469 8.74796 0.639501 28.6352 -16.9877 -21.8389 -3287 4 11.7753 8.08291 0.592641 -4.28958 7.52309 -10.9298 -3288 6 15.7499 31.9609 31.3743 -17.6212 -20.5964 15.467 -3289 4 14.8817 31.9157 30.9761 -10.6343 5.00824 -7.09118 -3290 4 16.0827 32.8403 31.1978 10.1106 0.369155 -2.88897 -3291 6 20.3726 39.1695 21.6147 20.5981 -29.5513 41.0934 -3292 4 19.9726 38.3531 21.9994 -5.82675 23.323 -22.8284 -3293 4 21.1172 39.24 22.2595 -11.0324 14.4144 -20.0969 -3294 6 38.8594 19.5251 7.6091 -6.47304 13.0289 -25.1371 -3295 4 38.0017 19.0955 7.57416 -1.20877 -0.517864 1.64758 -3296 4 39.1744 19.3685 8.48411 8.18586 -10.9486 17.219 -3297 6 41.3695 29.7301 21.1465 -57.7285 -14.4296 34.1578 -3298 4 41.7832 29.6286 20.3251 24.9116 3.74799 -36.1007 -3299 4 41.9865 29.9579 21.8177 26.2541 9.18996 12.3917 -3300 6 50.7039 33.8333 22.0593 7.50244 -20.9835 17.6314 -3301 4 50.9654 32.9474 22.4123 -1.20949 24.7473 -8.4765 -3302 4 50.362 33.6446 21.1779 1.66119 1.27804 -3.63001 -3303 6 18.1671 11.1714 14.3658 -12.4278 -6.78987 13.7569 -3304 4 18.0724 11.2679 15.338 -0.312443 2.59996 -20.4321 -3305 4 19.115 11.0923 14.227 4.83391 -0.924272 -3.79066 -3306 6 48.5058 14.2689 15.2513 -36.7782 -21.7282 -18.3567 -3307 4 49.3677 14.5693 15.4148 44.1026 10.3807 8.68918 -3308 4 48.5803 13.5893 14.5426 -8.44167 10.5166 12.8885 -3309 6 32.9801 15.74 8.25484 19.5805 1.81858 6.30948 -3310 4 33.8151 15.5666 7.78828 -7.72407 0.576521 2.61047 -3311 4 33.2057 15.7253 9.21147 -5.47651 1.26655 -15.0149 -3312 6 42.9141 4.85593 18.7596 35.6338 16.8786 18.3104 -3313 4 43.0674 5.82698 18.891 -14.0493 -22.2454 -3.89051 -3314 4 43.7794 4.50634 19.0974 -23.5505 0.71427 -17.3058 -3315 6 10.488 23.7131 33.4436 27.6073 45.1219 -14.7699 -3316 4 10.638 24.6985 33.3892 -15.3766 -28.1208 6.63949 -3317 4 11.1638 23.4099 32.8243 -6.46894 -14.1785 5.09081 -3318 6 1.12582 20.0662 11.2775 2.81918 8.09367 56.8435 -3319 4 0.488344 19.3589 11.407 -2.14544 -6.99577 -20.9797 -3320 4 1.17571 20.424 12.22 2.69463 -2.11621 -44.733 -3321 6 1.50824 39.5346 14.3079 -5.25271 -28.0543 15.9462 -3322 4 0.868346 40.1487 14.6984 3.61457 -0.641003 -8.28938 -3323 4 1.2571 38.629 14.6571 12.5115 33.2201 -10.0417 -3324 6 8.3332 21.6069 14.1357 -16.8636 -16.8509 36.8071 -3325 4 8.17334 21.0976 14.9962 5.25323 23.3985 -29.627 -3326 4 7.56323 21.4407 13.5807 -3.95337 3.79773 -2.56685 -3327 6 7.16177 13.3249 38.2255 -6.34169 -18.8056 -1.32195 -3328 4 6.69256 13.0329 37.4043 9.76156 12.0715 20.3406 -3329 4 7.43529 14.2522 38.1581 -0.0118119 -11.8895 -14.491 -3330 6 46.6212 1.64167 18.6867 -0.0463537 -24.1078 41.7639 -3331 4 47.541 1.5611 18.992 -0.862753 9.16913 -10.8716 -3332 4 46.1606 1.36736 19.5239 4.43612 14.9978 -24.7224 -3333 6 4.08147 8.39338 14.788 26.1694 13.8207 2.32184 -3334 4 3.41636 8.28931 15.4347 -29.1417 0.0985708 23.0338 -3335 4 3.90156 7.69349 14.1818 -2.47935 -14.3959 -27.3016 -3336 6 47.5712 36.5372 17.8422 14.6219 44.3363 14.3039 -3337 4 47.1691 35.7037 17.6938 -6.70251 -40.3849 -9.96305 -3338 4 48.5299 36.4434 17.8412 5.708 -14.7801 -1.83759 -3339 6 48.7177 32.6293 3.61477 24.5557 -7.82504 -30.2396 -3340 4 49.3183 32.0587 3.09719 0.221751 18.4164 7.83871 -3341 4 48.4066 32.0299 4.25286 -21.3126 -17.4552 36.5328 -3342 6 26.8672 34.4113 15.184 7.18591 -12.831 -4.85448 -3343 4 27.1806 33.7337 15.7866 -5.2278 -3.11582 5.08403 -3344 4 27.3382 34.1395 14.3734 -5.71629 20.1707 6.74573 -3345 6 9.99603 27.3398 13.3337 -11.5184 -70.0362 -20.4383 -3346 4 9.96963 28.1856 12.9595 -3.0362 48.3298 -16.8459 -3347 4 9.789 26.7159 12.5598 12.8825 26.2078 29.4693 -3348 6 2.39106 26.8936 37.3456 -18.0299 -5.48602 7.48259 -3349 4 2.24944 26.7597 38.2955 12.6258 0.126767 -1.18485 -3350 4 3.33209 26.9598 37.1993 18.2818 -0.192027 1.55797 -3351 6 33.3384 17.273 36.7956 -4.69576 6.00605 30.6641 -3352 4 32.3777 17.4022 36.9421 6.35755 -1.66054 -12.3647 -3353 4 33.5147 17.1107 35.8745 -6.55426 -0.461729 -19.8283 -3354 6 10.6704 18.7989 9.29568 -2.62714 4.796 -4.28658 -3355 4 10.7729 18.8103 8.31395 -3.57004 -0.312677 18.1362 -3356 4 10.9356 19.679 9.6198 -4.15772 -1.10699 -11.1079 -3357 6 8.58029 27.4085 3.13543 -0.646896 -38.9365 14.7517 -3358 4 8.62134 27.4642 4.10772 -2.35878 18.0768 -8.00568 -3359 4 8.54298 26.4189 3.06204 -3.80038 30.3142 -4.62402 -3360 6 40.6121 33.9148 14.3433 -13.4775 28.2536 -12.7531 -3361 4 40.8898 33.2957 14.9932 8.13038 -23.145 12.8628 -3362 4 40.1237 34.5547 14.8716 -1.64981 1.12342 -7.13376 -3363 6 54.0126 16.7742 13.6402 -25.2384 12.1291 10.4483 -3364 4 54.0311 17.2666 12.8352 12.7766 5.78776 -30.0788 -3365 4 53.1083 16.9555 13.9311 3.38038 0.740926 17.4694 -3366 6 39.1613 38.4947 7.40674 -49.2832 -1.36929 38.9537 -3367 4 38.8094 38.4839 6.52049 1.87105 5.40513 -14.0728 -3368 4 38.3203 38.5292 7.99504 41.7155 2.10662 -28.5328 -3369 6 42.2152 33.6749 29.0207 -49.4578 14.7313 -27.4402 -3370 4 42.0113 34.6279 28.8262 15.7605 -21.0767 3.4048 -3371 4 41.3749 33.2313 28.6743 34.021 9.03137 24.2205 -3372 6 2.84529 0.06018 20.1342 1.75144 -0.125494 -5.27144 -3373 4 2.85876 0.453048 19.2323 -10.3946 -7.40064 8.89792 -3374 4 1.95714 41.5787 20.3005 13.5701 9.63706 -6.70109 -3375 6 24.9846 26.9367 24.435 4.97654 17.1262 30.4362 -3376 4 25.3707 26.0628 24.5275 -2.48626 -13.7157 -10.817 -3377 4 25.1946 27.3852 25.2847 -1.69157 -3.92554 -20.3381 -3378 6 13.6202 33.989 7.00835 -29.3159 10.7937 -13.6787 -3379 4 14.4707 33.6317 6.76766 5.19255 -3.31821 -12.8703 -3380 4 13.1262 34.2356 6.16936 24.7045 -4.21039 25.9053 -3381 6 17.6361 31.8361 3.38698 11.6752 63.8731 -26.646 -3382 4 17.3765 32.06 2.46015 3.81419 -8.12146 27.658 -3383 4 17.5414 30.922 3.45915 -17.4061 -53.1647 5.72422 -3384 6 31.114 29.8463 35.9142 20.4735 12.0385 -23.871 -3385 4 30.4046 29.6578 36.4892 -25.9224 -10.1565 23.4082 -3386 4 31.8798 29.3863 36.2596 4.49336 -0.641295 3.24883 -3387 6 31.4544 1.69927 1.93203 61.0942 61.1307 23.4408 -3388 4 30.847 1.03155 1.81447 -56.5376 -48.8621 -2.33617 -3389 4 31.1234 2.33851 2.60628 -4.67927 -17.7811 -18.4359 -3390 6 13.7206 9.35179 12.308 -20.4886 -14.5553 22.3614 -3391 4 13.8994 10.2254 12.0406 16.2488 33.284 -13.5816 -3392 4 13.1923 9.47724 13.1212 6.47756 -14.062 -7.29461 -3393 6 15.2915 15.1706 12.1407 -39.3514 -20.6771 -15.8676 -3394 4 14.288 15.1355 12.0691 34.6095 3.19954 13.2467 -3395 4 15.5721 14.5705 11.433 2.70369 1.94224 0.817449 -3396 6 44.9298 30.4448 13.0945 -83.0621 -13.8007 20.4391 -3397 4 45.2326 30.6692 13.9612 22.7288 5.76966 14.7184 -3398 4 45.5619 30.4921 12.4362 58.1466 4.79773 -38.6719 -3399 6 35.1494 37.6283 24.8564 -28.9971 -18.9514 34.2227 -3400 4 34.5453 38.351 25.1691 15.7809 -12.2194 -9.31628 -3401 4 34.8969 36.8477 25.46 15.2444 28.3361 -22.0595 -3402 6 43.9018 19.2999 12.9893 -4.23684 -28.8047 14.7243 -3403 4 43.7111 18.3276 12.9437 8.07938 21.0179 -2.3859 -3404 4 44.434 19.3703 13.8064 -8.2748 4.27416 -6.23054 -3405 6 14.1928 27.3824 16.8974 17.9721 24.801 -15.5057 -3406 4 13.3941 26.8971 17.049 -12.9837 -13.2841 -1.45311 -3407 4 14.075 27.8458 16.0392 0.928992 -14.2323 10.6565 -3408 6 5.07867 37.4759 15.7278 -19.2695 5.34987 61.0101 -3409 4 5.83402 37.4907 16.3496 5.41141 -1.20808 -8.02024 -3410 4 5.40595 37.3511 14.8725 27.2981 -13.142 -45.6678 -3411 6 35.4792 36.9736 33.2279 -33.1303 3.22524 14.2013 -3412 4 36.4062 37.0387 33.1707 43.394 6.70104 -6.41693 -3413 4 35.2647 37.5361 33.9926 -10.1497 -5.08286 -5.32556 -3414 6 6.63713 31.7122 32.9951 -15.6769 -13.4095 -29.903 -3415 4 7.30356 31.0631 32.7808 0.413821 -11.0386 -1.85208 -3416 4 7.01801 32.1732 33.7097 9.96672 21.2943 24.541 -3417 6 31.2686 20.2272 25.4717 1.63607 -11.2998 14.888 -3418 4 30.457 20.1188 26.0175 18.7046 8.55246 -6.40474 -3419 4 30.9671 20.3507 24.5747 -9.02709 8.2981 -6.80006 -3420 6 54.9594 26.0897 7.3541 -26.2324 -3.52234 4.1817 -3421 4 54.3149 26.536 6.76189 8.45344 -4.14623 9.81761 -3422 4 54.4064 25.6921 8.06559 9.60693 6.10548 -13.0393 -3423 6 17.8786 35.1581 24.3912 -48.4608 -31.2574 -23.2844 -3424 4 17.9034 34.576 25.1672 15.4891 12.513 -1.90366 -3425 4 17.14 34.695 23.8716 34.0055 23.8611 10.1154 -3426 6 49.1404 3.30993 19.753 -11.7437 -5.45724 -22.9314 -3427 4 48.7379 4.07245 20.162 -0.785462 12.6857 6.5087 -3428 4 49.8408 3.03849 20.3377 4.84054 -6.57183 8.59361 -3429 6 30.2791 35.6014 13.4902 -0.275976 1.62471 9.45881 -3430 4 29.4038 35.7322 13.1068 5.01216 -3.78726 -8.18413 -3431 4 30.1007 35.4484 14.4302 1.26073 -0.50544 -4.60872 -3432 6 43.3857 25.8788 41.6729 -28.3599 -13.2186 -4.43344 -3433 4 44.0236 25.6058 41.0289 13.0372 -2.28568 -15.7328 -3434 4 43.8192 26.4334 0.378509 18.4346 21.3926 23.5205 -3435 6 21.1033 23.1572 6.40534 -12.8895 6.60285 13.2505 -3436 4 21.2833 23.9599 6.94372 3.68538 -20.4677 -7.26612 -3437 4 21.2354 23.4378 5.50624 8.61756 6.39287 -19.4039 -3438 6 54.6209 21.1977 19.0953 -9.4905 16.5472 15.3455 -3439 4 0.355231 21.543 19.6762 -10.082 -5.94448 -19.8865 -3440 4 53.803 21.6498 19.4211 22.178 -8.62035 -3.94206 -3441 6 13.8696 38.9444 18.7589 -0.408574 -9.95072 10.686 -3442 4 13.5473 38.5195 19.5701 -4.79749 -3.34053 -10.6661 -3443 4 14.2783 39.7511 19.0654 -4.68159 17.5572 -2.41189 -3444 6 39.1837 2.73799 39.6933 -2.22487 -14.248 -19.2211 -3445 4 38.5048 2.18054 40.1045 3.50502 9.25929 9.72195 -3446 4 39.1752 2.3966 38.7788 -3.09486 7.3066 6.14055 -3447 6 43.2236 33.8218 8.83748 -23.7799 54.6507 -8.87946 -3448 4 43.1776 32.9835 9.22653 -2.14792 -45.6212 21.4927 -3449 4 42.4318 34.327 9.18683 27.5752 -12.6709 -4.85681 -3450 6 23.0768 16.6786 12.1043 19.2201 -8.5648 -22.0864 -3451 4 23.4688 16.2415 11.3109 -7.42341 7.06352 19.0042 -3452 4 22.1329 16.714 11.9048 -3.02708 6.60369 6.72608 -3453 6 40.7875 26.1445 36.3165 -31.0446 26.1707 15.63 -3454 4 40.1182 26.8831 36.2336 22.2291 -27.8038 4.66075 -3455 4 41.0346 25.9172 35.4285 12.0382 -0.567557 -16.236 -3456 6 15.1503 11.6728 19.298 -10.8743 -20.3409 15.6657 -3457 4 15.4707 12.2619 18.6272 13.0208 17.9076 -10.0848 -3458 4 15.518 11.9699 20.1418 -0.780585 5.28883 -4.88637 -3459 6 9.8485 29.8084 31.3808 31.6725 31.0987 -15.032 -3460 4 10.6075 30.172 31.8684 -9.75043 -12.6573 12.7307 -3461 4 9.98584 30.2945 30.5336 -20.1344 -22.7331 8.89086 -3462 6 2.12557 30.0341 25.264 -3.96851 -24.8252 -11.595 -3463 4 2.04755 29.1979 25.7442 2.8488 12.5065 4.07713 -3464 4 2.06741 29.7398 24.3306 5.27272 21.1251 20.17 -3465 6 49.0124 10.6515 7.04668 12.8278 -6.79775 19.6819 -3466 4 49.7765 10.456 7.62014 -4.12072 9.88663 -9.32692 -3467 4 48.4954 9.84699 7.16976 -12.5497 -3.43755 -7.74842 -3468 6 38.6385 34.4247 32.4851 8.7415 15.3068 2.26745 -3469 4 38.2449 35.2411 32.8392 7.79483 -2.42751 -9.0272 -3470 4 38.3877 33.7513 33.1114 -5.41613 -8.85245 5.88093 -3471 6 24.2967 24.7175 4.7858 -13.8074 20.2372 -8.25903 -3472 4 24.5879 23.8747 5.12331 8.49271 -10.4438 10.0312 -3473 4 24.0688 25.3355 5.52385 7.10746 -21.4288 -14.6014 -3474 6 44.0211 23.587 33.7713 -18.8641 -18.6234 -6.9532 -3475 4 43.6265 23.0569 33.047 -3.30007 6.44469 22.3225 -3476 4 44.7839 23.9213 33.3479 32.8249 22.1868 -7.88886 -3477 6 45.135 31.9539 26.6318 17.8742 -16.5206 -32.2352 -3478 4 44.6965 32.0125 27.458 -12.8805 4.46476 28.7394 -3479 4 45.0195 31.023 26.337 -1.34861 17.8758 10.4404 -3480 6 52.0545 6.36303 22.865 -1.87051 -30.929 -4.90791 -3481 4 51.4549 5.58836 23.0553 13.7734 29.2588 0.606927 -3482 4 51.4955 7.14596 22.8951 -3.5837 -3.73437 -5.39564 -3483 6 5.1124 17.7016 30.4663 -17.3022 -2.39818 -4.94531 -3484 4 5.57517 17.705 29.6436 5.33167 -14.42 -26.4334 -3485 4 5.6774 18.2653 30.9495 12.7188 16.8745 32.2475 -3486 6 48.5399 17.0091 6.52669 31.3107 25.6813 -22.3666 -3487 4 48.2466 16.108 6.56632 -4.44525 -18.5722 0.0807757 -3488 4 49.3123 17.0767 5.87973 -32.0368 -4.22047 21.2267 -3489 6 13.8017 31.3286 23.4652 -45.3568 -0.340859 23.461 -3490 4 14.0246 31.2001 24.3905 13.6426 -1.74144 -0.768444 -3491 4 14.5269 31.1963 22.8948 44.8358 -8.96568 -14.3918 -3492 6 28.4984 33.4231 26.025 30.2115 45.129 -4.70205 -3493 4 28.7629 32.7421 25.4284 0.749934 -18.6264 -12.7861 -3494 4 27.7356 33.1626 26.4825 -33.9251 -20.2776 22.3239 -3495 6 9.04101 22.9533 11.0101 4.17271 5.63899 8.67886 -3496 4 9.24243 22.776 10.0879 9.05926 -1.29962 -0.957415 -3497 4 9.84172 22.774 11.5341 -6.79246 0.647577 -9.3095 -3498 6 40.5624 4.0706 26.5792 43.7479 -58.1273 15.512 -3499 4 40.0377 4.03321 27.356 -14.6911 0.39925 31.4188 -3500 4 40.1771 4.74143 26.1095 -33.6389 57.2603 -43.6855 -3501 6 17.0606 37.9689 20.9328 24.9068 -2.83666 19.2437 -3502 4 17.7492 37.7057 21.5806 -0.23423 0.332892 -22.3637 -3503 4 16.3 37.9671 21.4825 -28.3901 -0.1668 6.57955 -3504 6 31.9758 6.36253 14.1925 -47.1359 -2.961 8.2158 -3505 4 31.6652 5.47044 14.4516 -0.57512 5.53961 -9.89258 -3506 4 32.9075 6.27907 14.242 33.1863 -3.34593 -3.73058 -3507 6 29.3613 34.9484 39.6522 -7.7658 6.78361 -10.4711 -3508 4 29.4154 34.7255 40.5688 2.48129 -3.65799 19.6008 -3509 4 28.4079 35.1232 39.5563 9.75382 -5.50564 -9.65046 -3510 6 22.5642 2.93231 32.1024 7.89654 -13.571 4.24933 -3511 4 23.152 3.60479 31.7467 -0.797152 8.5773 -0.128413 -3512 4 22.8746 2.10235 31.6905 -8.86372 14.3523 0.842504 -3513 6 51.7365 19.0888 24.8036 24.4352 10.6631 34.2631 -3514 4 52.2011 19.3182 25.6664 -22.8444 -5.9403 -33.5217 -3515 4 52.2256 19.5376 24.1035 -3.13425 5.18677 -1.50107 -3516 6 32.1309 13.661 24.2221 8.32979 -1.22201 -48.3483 -3517 4 32.1718 13.7834 25.1379 3.34806 7.10631 53.6256 -3518 4 31.2192 13.5434 23.9915 -25.9097 -1.66347 2.1781 -3519 6 9.49478 30.1756 28.7975 -1.02802 7.68553 8.51386 -3520 4 8.9614 29.4447 28.4635 3.13242 -3.87437 -3.11369 -3521 4 9.76139 30.7024 28.0341 -4.99689 -6.39164 -2.13333 -3522 6 31.3017 3.1328 24.0821 -2.56057 -13.3126 7.41322 -3523 4 30.8642 3.97896 23.9468 1.03353 -0.10231 -3.56587 -3524 4 32.1597 3.13825 23.6386 1.18226 10.803 -0.447916 -3525 6 2.13915 19.8328 36.4477 43.9795 26.8161 3.66972 -3526 4 3.0929 19.9274 36.115 -41.9598 -16.8793 8.64164 -3527 4 1.76662 18.9777 36.2517 -5.24508 -9.86619 -11.2286 -3528 6 36.9558 16.7701 14.0992 8.10199 -24.1685 -1.60142 -3529 4 37.0878 17.1202 14.9938 -3.44507 3.84646 -3.58016 -3530 4 37.3137 15.854 14.1066 -5.27996 15.1268 -1.92478 -3531 6 1.82451 11.1811 6.08431 4.75441 9.84221 -14.5701 -3532 4 1.68522 10.3449 6.52934 -2.64515 -5.74712 4.44833 -3533 4 1.45572 11.848 6.66197 -6.16769 2.71123 7.45582 -3534 6 43.1467 36.8536 25.2684 -4.34259 -25.2275 5.76074 -3535 4 42.489 36.6679 24.5813 -1.65581 9.08703 8.09798 -3536 4 42.9757 36.1566 25.9418 7.67001 18.3814 -10.5814 -3537 6 32.1358 5.54258 7.00813 -0.159667 5.03525 -3.02009 -3538 4 31.8447 4.70695 7.37259 1.76357 -8.94122 3.22744 -3539 4 31.6184 6.21523 7.45425 -7.92944 5.35442 3.67752 -3540 6 15.0738 21.498 41.5176 2.48253 -6.99424 4.64434 -3541 4 14.4083 21.441 0.286083 -5.89506 -4.91034 13.0846 -3542 4 14.6326 22.02 40.8608 1.523 7.8898 -22.5967 -3543 6 37.0299 36.0573 5.68999 -1.26402 -4.33671 -4.68257 -3544 4 36.8992 36.8706 5.1864 -9.04185 9.38437 4.54051 -3545 4 36.6368 36.1345 6.57983 4.68584 5.64444 -6.17041 -3546 6 39.6378 22.8733 0.344261 -10.4835 1.90991 -1.04201 -3547 4 39.8967 23.7127 41.8596 6.32696 2.65577 1.7872 -3548 4 39.7641 22.9598 1.30287 2.84221 -4.68177 2.22816 -3549 6 18.471 23.1695 5.24444 18.17 13.8994 5.32385 -3550 4 18.2426 24.0888 5.07969 -12.1406 8.45165 -11.681 -3551 4 19.3434 23.2774 5.65727 -5.17221 -14.3673 2.51868 -3552 6 34.4951 26.4012 0.415196 -24.2262 -21.8504 23.5375 -3553 4 33.9567 27.1096 0.873351 15.2264 -25.8266 -5.88921 -3554 4 34.3584 25.5285 0.919462 6.17703 40.7497 -12.3351 -3555 6 28.1538 26.089 40.6186 -44.0465 -12.7539 23.8091 -3556 4 29.0676 25.9468 40.8623 9.74545 0.451611 8.45277 -3557 4 27.5517 25.6856 41.3354 31.2048 15.0133 -28.9196 -3558 6 41.7541 4.40312 30.2348 -21.1804 7.97019 15.7848 -3559 4 42.5951 3.9554 30.1474 10.5948 -6.90465 6.49815 -3560 4 41.6197 4.66064 31.1807 9.39609 -4.15263 -13.0838 -3561 6 4.45746 8.30422 29.123 17.0584 8.0822 12.8675 -3562 4 3.72424 8.78851 28.7689 -20.5564 0.917363 -10.5697 -3563 4 4.90241 9.00738 29.631 2.39094 -12.8625 -4.67793 -3564 6 12.9051 9.61174 32.1485 9.54391 19.7002 1.20842 -3565 4 12.5238 8.90328 31.6499 -4.6135 -18.7028 0.941221 -3566 4 13.4507 9.29961 32.8815 -5.77341 -6.01915 -0.606497 -3567 6 48.6524 16.2364 1.45279 -39.5117 19.3379 22.5337 -3568 4 49.5656 16.3395 1.57323 44.82 -2.42546 -4.76282 -3569 4 48.322 16.6449 2.29127 -2.06599 -18.2277 -23.678 -3570 6 26.4391 39.9942 21.1964 -5.73 55.7886 4.05886 -3571 4 27.1886 40.6225 21.0926 -13.7426 -7.13397 8.25982 -3572 4 26.7825 39.1793 20.9147 12.833 -38.7313 -7.54244 -3573 6 35.8074 4.09236 9.03492 -45.4698 -15.3304 -15.5709 -3574 4 35.5046 4.67089 8.30824 2.24043 1.80806 6.22839 -3575 4 34.9768 3.81452 9.52186 26.5657 10.3238 -8.47709 -3576 6 52.6895 3.55751 27.8666 50.2867 -19.9176 -34.5196 -3577 4 53.5586 3.5996 28.3549 -33.5645 -3.53647 -1.9565 -3578 4 53.0019 3.22463 26.9489 -24.4009 21.759 36.9675 -3579 6 48.3192 26.6913 27.3954 13.1896 -37.7442 -6.45526 -3580 4 48.9722 25.929 27.4853 -22.116 34.446 0.770506 -3581 4 48.7243 27.4862 27.7371 6.43066 9.80699 11.7315 -3582 6 24.507 4.96042 18.7259 -17.59 -10.4057 14.9036 -3583 4 24.0519 4.20246 19.1729 14.2279 16.3534 -10.8515 -3584 4 23.9406 5.7442 18.8517 8.31711 -9.56192 -0.149656 -3585 6 24.0493 12.473 28.7688 20.4432 11.2466 2.34496 -3586 4 23.2439 12.9627 28.9427 -11.3477 -3.77152 -2.6943 -3587 4 23.8404 11.6087 28.4204 -6.74951 -3.90152 -5.01594 -3588 6 40.1637 27.7353 40.8087 -33.5791 -9.4694 0.953173 -3589 4 40.5641 26.9832 41.236 1.78301 2.25495 0.260865 -3590 4 39.2218 27.4214 40.7917 21.7476 20.7917 -9.34619 -3591 6 11.9335 13.5538 26.9488 -1.21599 4.57236 -11.9259 -3592 4 11.0364 13.8177 27.1576 -7.67129 -6.9102 2.53909 -3593 4 12.2164 12.9501 27.6309 4.70555 -13.4351 6.55277 -3594 6 52.1924 29.5424 41.3942 11.5626 -24.8936 -19.0003 -3595 4 51.8104 30.1965 0.050158 4.44506 23.3375 14.6186 -3596 4 53.1351 29.3771 41.6391 -10.5303 1.44862 4.74126 -3597 6 17.4882 19.0285 39.1853 -8.07927 32.7478 0.0743051 -3598 4 17.5012 19.6463 39.9647 -0.891206 -23.8414 -20.0908 -3599 4 17.261 19.5796 38.3923 8.05332 -16.519 21.1694 -3600 6 46.2326 27.6801 33.704 6.45393 -8.86534 7.23017 -3601 4 46.097 28.3723 33.048 -4.6559 5.79968 -1.93617 -3602 4 45.5979 27.7746 34.4233 -3.33861 16.4707 5.34235 -3603 6 35.8364 29.5448 5.62541 9.64171 -18.9009 -6.27826 -3604 4 35.5566 29.3199 4.72548 3.62776 14.0584 -3.56087 -3605 4 35.3944 30.354 5.86953 -6.57081 16.5188 2.47276 -3606 6 47.2881 25.7744 30.172 -6.62968 25.0044 -44.0548 -3607 4 48.1218 25.8653 29.6696 -5.94381 -7.49802 14.0131 -3608 4 46.6882 26.3745 29.6449 8.85802 -15.1094 17.4745 -3609 6 51.3842 12.359 20.0239 24.4626 17.3052 -5.31346 -3610 4 50.8707 12.833 19.3583 -10.0057 -7.98386 3.51527 -3611 4 50.8448 11.6564 20.3722 -11.0446 -8.70835 7.6307 -3612 6 41.976 18.3776 28.9581 25.2971 -7.26912 -18.3725 -3613 4 42.7018 17.9973 28.405 -17.3573 7.64094 3.96866 -3614 4 42.4517 18.9921 29.5246 -2.74764 -0.293653 0.793262 -3615 6 53.6043 6.48027 7.50524 -23.0657 -32.6432 -30.9738 -3616 4 53.1601 5.59498 7.33399 18.2827 28.6912 7.08019 -3617 4 53.6632 6.576 8.44633 9.6706 -3.87944 16.2616 -3618 6 9.90786 10.6094 26.7582 6.17728 8.73826 28.1859 -3619 4 10.299 10.3755 27.6331 -6.59671 -6.24018 -20.7073 -3620 4 9.65116 11.5299 26.9247 0.732239 -5.98194 -12.944 -3621 6 9.31054 39.3957 29.7756 40.7644 23.7808 19.8799 -3622 4 10.1982 39.3563 30.2561 -34.3316 0.809436 -14.8313 -3623 4 8.83679 40.1565 30.1832 5.55001 -15.1294 -12.8037 -3624 6 33.4099 4.77839 0.03236 -17.6047 -18.7695 14.8321 -3625 4 33.6454 5.53147 41.4176 15.8926 12.9618 -7.52592 -3626 4 34.0969 4.09847 41.8942 -0.186489 10.0102 -3.03658 -3627 6 35.7116 10.6673 34.2398 36.7653 -21.2814 -15.2586 -3628 4 35.2554 10.867 35.0388 -18.8422 0.575424 27.4634 -3629 4 36.4577 10.0619 34.4978 -21.6361 17.9445 -5.28322 -3630 6 15.2039 17.4016 19.1867 13.7018 -34.0248 -48.7675 -3631 4 15.5709 16.9982 18.3093 -23.7907 16.5473 43.0322 -3632 4 14.2523 17.472 19.021 -2.02403 4.48523 -0.714523 -3633 6 17.4757 37.6682 15.4227 -5.7624 0.927264 51.2416 -3634 4 17.0409 37.838 16.3209 3.67045 -5.85113 -35.7653 -3635 4 18.3529 37.3927 15.7202 1.879 4.38305 -13.464 -3636 6 26.263 8.20496 21.7043 -12.9193 13.0258 38.8746 -3637 4 26.2935 8.46487 22.6678 13.4631 -3.74504 -28.0146 -3638 4 25.3122 8.09558 21.5911 -4.90698 -1.77416 -12.6216 -3639 6 0.327844 9.89683 15.4174 -28.4002 -4.57955 -27.8061 -3640 4 1.20252 9.6859 15.1701 33.2298 -8.84956 3.25601 -3641 4 54.8213 9.3498 14.7471 -0.695723 21.8052 24.8209 -3642 6 13.451 40.6616 9.29616 -29.1589 -29.1317 3.11657 -3643 4 12.531 40.2581 9.2528 27.9164 27.237 1.6895 -3644 4 13.9533 39.998 9.7876 1.76749 3.89663 -1.50565 -3645 6 49.5605 25.9144 33.0102 6.77982 -23.7672 54.8124 -3646 4 50.0733 25.5846 33.8473 -25.1648 19.9091 -52.5505 -3647 4 48.6275 25.6453 33.15 14.5478 0.915879 -9.46863 -3648 6 37.0796 40.0419 26.4359 -26.9931 13.9721 12.3681 -3649 4 36.1882 39.5442 26.6099 42.8933 36.2545 -2.50818 -3650 4 37.051 41.026 26.6764 -12.8506 -44.3362 -9.04112 -3651 6 47.9916 17.8545 12.1553 -7.21137 29.6324 -37.7219 -3652 4 47.6652 18.6843 11.7058 6.42171 -29.0319 9.52509 -3653 4 47.7397 17.941 13.056 -8.12129 -2.80141 29.1943 -3654 6 27.9724 29.0571 34.165 6.45289 -21.5611 -2.40729 -3655 4 28.8948 28.8211 34.3683 -10.3018 1.8492 -2.91154 -3656 4 27.944 30.0064 34.1676 -0.713497 24.9251 0.854011 -3657 6 33.997 2.77014 13.2231 -35.3168 39.3397 6.14274 -3658 4 33.7592 2.40426 14.0871 -4.38792 -6.80294 -4.34532 -3659 4 34.7545 2.32608 12.931 40.4814 -27.3629 -5.76242 -3660 6 28.4454 36.033 11.4537 -30.811 -5.98685 22.1865 -3661 4 27.9997 35.3658 10.9161 0.521783 -1.73573 4.3727 -3662 4 28.9676 36.474 10.8303 31.7187 19.1344 -28.008 -3663 6 36.1836 11.3675 28.8638 -20.2526 -8.96451 -46.9053 -3664 4 35.201 11.3136 28.8426 17.393 5.15327 13.3727 -3665 4 36.3619 11.2493 27.8855 5.85658 3.26624 29.9739 -3666 6 24.7946 39.4802 16.9069 19.0937 3.96627 -8.4872 -3667 4 24.3751 40.345 16.9988 -5.97342 -3.52606 0.908874 -3668 4 24.9466 39.3518 15.9585 -10.9099 3.48913 2.54936 -3669 6 49.9504 8.05659 22.8451 -38.4139 -9.47108 -34.4931 -3670 4 49.9375 7.9588 23.7925 -16.1787 -3.75115 16.4902 -3671 4 49.0231 7.8493 22.4633 39.8101 3.17892 24.2331 -3672 6 52.1004 19.3469 10.2236 -1.12118 28.0811 1.24376 -3673 4 51.6057 19.3908 9.40186 -4.74475 -17.9853 -5.36861 -3674 4 52.3066 20.3081 10.2872 8.90847 -30.6944 7.30622 -3675 6 24.8344 15.8907 6.13046 -10.5287 3.62194 6.20212 -3676 4 24.2343 16.3288 6.78807 10.5214 -9.32926 -18.7028 -3677 4 24.4584 16.0701 5.24836 4.34413 4.47582 9.48796 -3678 6 49.3142 23.7074 8.6354 12.7826 -64.5552 32.8663 -3679 4 49.2168 22.9153 9.25307 13.1077 36.9849 -24.4484 -3680 4 48.4233 23.9587 8.46247 -20.5325 16.4959 -12.9251 -3681 6 0.200228 10.6387 32.1899 4.57462 9.08702 -50.3173 -3682 4 1.12405 10.3631 32.1441 4.84637 -6.06001 20.7538 -3683 4 54.8206 10.7585 33.0477 -1.25869 -8.0958 33.7963 -3684 6 12.5866 32.9145 13.2359 -45.84 -1.33101 12.3773 -3685 4 11.7384 33.4448 13.1799 26.1773 -16.8128 -1.90055 -3686 4 13.2757 33.4614 12.9111 20.4647 17.7705 -9.07485 -3687 6 21.729 32.5695 14.1172 -9.28791 -20.3928 5.37861 -3688 4 21.166 33.3661 14.1597 2.78901 -9.86158 3.94413 -3689 4 21.3002 31.8069 14.587 7.27427 31.5827 -10.8786 -3690 6 48.1522 34.8482 27.3304 1.15431 -17.6089 -40.5894 -3691 4 47.5385 35.1725 27.9994 -6.04073 -2.93057 -0.479876 -3692 4 47.6796 34.4132 26.5454 8.99615 21.2578 35.6726 -3693 6 45.6357 31.2393 36.095 -40.8957 20.4658 25.2026 -3694 4 45.8476 31.9489 35.493 1.2761 6.76392 -14.6383 -3695 4 44.8829 31.5945 36.6582 19.8537 -10.4851 -18.3708 -3696 6 46.2846 0.316369 14.3569 -23.6541 -29.5796 11.0344 -3697 4 46.2347 1.24867 14.1822 6.12226 14.592 -0.646978 -3698 4 47.172 41.8876 14.3137 22.6277 5.76419 -11.0491 -3699 6 14.3437 18.9821 40.2104 -25.2995 -33.3041 -15.9392 -3700 4 14.4094 19.2869 39.3238 4.54227 2.45102 -23.4893 -3701 4 14.593 19.7098 40.7196 18.3341 34.8836 33.2243 -3702 6 14.5595 1.13832 10.2184 21.0915 11.237 11.4523 -3703 4 15.4791 1.15983 9.85648 -24.9846 -0.242798 0.374642 -3704 4 14.0639 0.416501 9.81608 3.47586 -8.24251 -5.69878 -3705 6 34.4238 40.9137 13.0059 -4.24882 -26.6665 -25.0696 -3706 4 34.0907 40.4301 12.2099 6.6876 25.2293 12.1693 -3707 4 34.3655 40.2093 13.6737 -1.45879 20.9599 -0.365544 -3708 6 42.1372 25.6317 33.9946 32.9644 -29.1434 -4.32848 -3709 4 41.7256 25.3671 33.1599 -4.34041 1.82357 5.58197 -3710 4 42.8775 24.9612 34.1276 -26.6125 21.4128 -4.76888 -3711 6 29.2041 22.5904 40.0709 -12.2401 -3.24737 -11.2113 -3712 4 28.5312 23.0545 39.5673 2.40343 6.95864 -1.48823 -3713 4 29.0042 22.7646 40.9807 1.44808 0.219743 17.343 -3714 6 44.8039 18.6198 1.5029 3.83338 16.5679 14.3409 -3715 4 44.9659 19.0204 2.39019 -3.90529 -17.866 -14.3425 -3716 4 44.0478 19.1074 1.16429 2.25905 3.06151 -3.31671 -3717 6 4.48486 10.8191 23.9456 -47.6019 -35.9978 3.19751 -3718 4 5.13394 11.3869 23.6113 33.8353 31.137 -11.4748 -3719 4 4.52769 10.7271 24.8961 2.68899 9.9192 5.78369 -3720 6 6.46393 23.0191 29.0034 23.802 4.69353 23.6764 -3721 4 7.14249 23.0161 29.7285 -18.6834 17.7038 -21.9419 -3722 4 6.49076 22.0968 28.8008 -10.0115 -22.5628 -12.4771 -3723 6 39.7912 25.1434 32.5739 17.5205 -18.6836 -60.5647 -3724 4 39.6128 25.3468 33.4485 -16.6712 22.7672 53.7369 -3725 4 39.6667 25.9357 32.0325 -1.3786 -0.359445 4.68486 -3726 6 40.844 21.4875 8.87812 10.6958 -1.16061 -24.4784 -3727 4 40.753 21.3778 7.91779 -6.86728 3.07162 8.13114 -3728 4 41.3272 20.6946 9.13123 4.7165 -6.17308 11.2164 -3729 6 0.614957 1.42802 12.9561 35.282 30.4207 -35.1483 -3730 4 54.8795 1.90166 12.5287 -4.84596 -15.7095 11.3484 -3731 4 0.325279 0.716474 13.4972 -22.2917 -16.9379 18.816 -3732 6 32.6687 29.7155 23.4821 0.172893 -14.8348 21.3896 -3733 4 32.2937 28.8037 23.5347 8.27316 18.2339 -7.75927 -3734 4 32.5776 29.9928 22.5742 -5.86304 -0.191283 -15.879 -3735 6 12.5314 37.1515 20.4729 45.6241 64.5302 32.6184 -3736 4 13.0675 37.1561 21.3077 -14.1528 -0.638655 -18.1117 -3737 4 12.0966 36.3476 20.454 -27.4762 -63.6198 -6.10217 -3738 6 13.8924 14.5151 24.69 -3.15938 -4.02598 20.115 -3739 4 13.491 15.2498 24.2338 -4.44789 9.69439 -9.34194 -3740 4 14.0279 14.8194 25.6039 -0.281954 0.872924 -9.09093 -3741 6 17.5021 27.063 26.4741 18.9499 -7.93165 -17.7551 -3742 4 17.3645 27.9616 26.0981 5.20292 -20.1733 2.46217 -3743 4 18.105 26.551 25.8503 -19.0729 23.9469 15.4793 -3744 6 54.4877 9.53021 26.3477 -5.78247 7.96784 25.4661 -3745 4 54.0512 10.3733 26.628 8.34027 -15.1138 -9.49744 -3746 4 54.8923 9.139 27.1544 -8.60221 9.32804 -13.3813 -3747 6 33.6807 21.5011 24.9225 20.8165 12.7411 -37.5161 -3748 4 33.6447 21.5342 23.9109 -0.857654 -11.0597 35.2787 -3749 4 32.8481 21.1477 25.2212 -19.5227 -6.82771 5.56304 -3750 6 22.1475 35.2701 2.885 -1.57378 -2.18642 30.1771 -3751 4 22.1887 34.3602 2.5781 3.09514 -3.18559 -9.19859 -3752 4 22.1072 35.1817 3.87164 0.12039 0.813186 -18.6146 -3753 6 45.3027 5.41438 15.6133 24.4211 -32.124 17.7203 -3754 4 45.2073 5.06649 16.5292 -4.89018 16.6426 -14.7318 -3755 4 44.541 5.92364 15.3615 -17.3903 4.72304 -1.03383 -3756 6 5.67534 7.5869 16.981 -5.47297 6.8358 -20.2139 -3757 4 5.25896 7.81046 16.1225 6.35918 -0.232773 12.9215 -3758 4 6.51331 8.07041 16.9918 4.7107 -6.94883 2.60141 -3759 6 34.576 39.0992 27.2053 24.5889 13.5844 -33.9491 -3760 4 34.3093 38.4547 27.8221 -16.0328 -19.2876 29.327 -3761 4 34.0621 39.904 27.3046 -7.96056 4.01318 13.6593 -3762 6 32.7541 33.6107 34.2903 -12.2088 11.6467 -22.6039 -3763 4 32.1008 34.0277 33.6489 27.9813 -13.6615 23.3944 -3764 4 32.6574 34.0489 35.1447 -11.8345 -0.637226 -0.957772 -3765 6 31.0088 41.2052 32.3952 -16.5884 -4.13679 -5.08533 -3766 4 30.2065 41.1942 32.9317 -1.71273 -1.00977 6.80252 -3767 4 30.9738 0.147898 31.9828 5.47722 15.337 -6.15299 -3768 6 7.65161 1.58314 27.1492 34.9115 -9.04616 -23.8477 -3769 4 8.49581 1.43905 26.61 -35.9655 -7.00487 18.1392 -3770 4 7.51162 2.51613 27.0476 -4.48076 16.5289 1.77021 -3771 6 0.884173 22.0999 37.8474 19.5684 -22.3581 -15.9684 -3772 4 1.29289 21.3236 37.3582 -15.3878 24.821 16.8607 -3773 4 1.19208 22.8872 37.3739 -1.97361 -3.14502 -0.467946 -3774 6 7.41204 11.1157 19.2314 -38.1481 -15.0427 -1.85178 -3775 4 7.53858 12.0593 19.2468 12.5581 17.6457 8.19935 -3776 4 8.2604 10.6916 19.3015 17.9889 5.14781 -4.65775 -3777 6 43.7858 12.4956 37.3097 0.920036 9.73958 -3.1733 -3778 4 43.9612 12.5094 36.3537 -0.436236 -2.21513 6.60981 -3779 4 44.6264 12.7918 37.692 -0.443403 -7.75914 -0.361508 -3780 6 29.0868 33.5248 36.1867 6.33086 18.8505 -43.8567 -3781 4 29.87 33.99 35.8176 -18.9328 -5.41066 10.4629 -3782 4 29.4633 33.0358 36.8874 15.3521 -14.5291 31.9885 -3783 6 14.802 4.59099 3.93345 20.4849 22.8827 12.2406 -3784 4 14.3757 4.0439 3.27797 -5.14737 -6.71868 -8.73832 -3785 4 15.6594 4.91612 3.57855 -16.4986 -14.1515 -5.85747 -3786 6 39.0551 6.39795 6.38864 -31.6963 1.09254 42.8867 -3787 4 39.3692 7.21691 6.04781 17.6944 18.3081 -17.2196 -3788 4 39.3538 5.69048 5.84285 10.6785 -8.50098 -20.4551 -3789 6 22.2123 37.9977 40.776 -14.7699 -23.2033 -28.4168 -3790 4 22.4586 38.8695 40.5021 9.68098 25.7962 -2.3277 -3791 4 22.4791 37.9118 41.6765 7.85923 -2.07179 26.9545 -3792 6 4.44877 23.2867 6.14309 -1.92846 -21.7963 14.7751 -3793 4 3.85981 23.8785 6.59389 -8.34079 22.3777 -5.30491 -3794 4 4.15148 22.4458 6.53602 18.5324 -1.87236 -10.5169 -3795 6 12.4298 23.7885 9.24819 15.5635 1.24594 19.7483 -3796 4 11.6299 23.5219 8.81427 -22.2296 0.449899 -3.14002 -3797 4 12.2156 24.1823 10.1208 2.55292 -1.37139 -18.7826 -3798 6 46.4922 15.2589 16.9667 3.22745 3.94864 2.0367 -3799 4 47.1791 14.9867 16.3488 -1.59454 -10.7105 -10.6804 -3800 4 46.8221 16.1143 17.2497 1.89409 2.98219 12.0057 -3801 6 34.1117 27.1644 19.7797 24.4736 -11.2812 21.2279 -3802 4 34.8774 26.5238 19.7962 -19.6491 14.1094 -6.20677 -3803 4 34.0324 27.4806 20.6991 -2.21978 -4.312 -16.0235 -3804 6 46.9479 13.2121 35.1109 14.7829 18.0264 15.8687 -3805 4 47.3232 14.0654 34.8894 8.1348 3.75559 6.81177 -3806 4 46.5576 12.9943 34.2929 -17.7211 -19.0679 -23.646 -3807 6 50.5883 18.7922 12.536 -4.97475 -8.40096 -18.6689 -3808 4 49.7377 18.4417 12.2063 9.85466 0.19572 8.20723 -3809 4 51.2037 18.6585 11.7837 -7.44169 10.1395 9.07394 -3810 6 32.4871 12.6357 31.9554 3.75694 -28.5712 -45.9238 -3811 4 32.607 11.6542 31.8864 5.47128 21.8321 9.55763 -3812 4 32.4011 12.8494 32.8587 -4.02679 2.16968 41.7104 -3813 6 6.20502 19.6778 10.0162 1.71901 21.9334 16.0314 -3814 4 6.41826 20.2441 9.25697 6.75258 -1.0862 1.44387 -3815 4 6.08129 20.3112 10.7738 2.93045 -16.0896 -19.0741 -3816 6 21.5254 21.5246 2.44441 10.1652 3.23891 -24.6245 -3817 4 21.7373 21.5014 1.49425 -3.90993 5.22039 4.49463 -3818 4 22.0841 20.8004 2.76184 -10.1442 1.98878 12.5692 -3819 6 38.3901 23.0895 17.1987 11.9637 -29.1373 -23.0023 -3820 4 38.7115 23.1739 16.2902 2.30233 23.4463 5.8212 -3821 4 38.6091 22.1461 17.2941 -10.4226 8.48715 23.8901 -3822 6 29.6992 24.9636 22.2212 38.6917 -37.4999 -9.7813 -3823 4 30.2244 25.0209 22.9989 19.9484 -5.9881 25.7874 -3824 4 29.0295 25.5321 22.4534 -63.588 46.0104 6.14599 -3825 6 30.2959 21.4331 37.7732 -36.6703 24.7369 -1.55525 -3826 4 30.3833 21.3736 36.7928 -5.6984 1.01251 23.2154 -3827 4 29.3642 21.7906 38.031 44.833 -25.8334 -23.6526 -3828 6 11.8968 11.712 16.3062 -52.2626 -16.509 -42.1992 -3829 4 11.3487 12.2512 16.8737 -4.04714 4.99791 6.8918 -3830 4 11.2749 11.5458 15.4981 35.5887 6.11969 38.645 -3831 6 5.69762 16.9728 10.4703 1.06122 -0.586779 5.28994 -3832 4 4.99177 17.1708 11.0979 -1.96678 -11.04 -5.71485 -3833 4 5.85288 17.8179 10.0528 3.40155 4.97172 -3.96907 -3834 6 41.7052 34.1635 35.8846 2.77529 22.9845 38.2917 -3835 4 41.9958 35.0267 36.2582 -8.6238 -19.1969 -5.00662 -3836 4 41.6615 34.3005 34.9574 -2.57818 -0.630621 -34.674 -3837 6 33.7668 1.16041 30.1021 -7.73366 -5.3538 60.0773 -3838 4 32.8437 1.27671 30.3431 -6.56672 10.3256 -18.6068 -3839 4 34.0939 1.04339 31.0463 15.1522 -1.22783 -40.312 -3840 6 50.3589 18.6227 36.9888 29.2523 22.0538 -2.88024 -3841 4 50.1022 18.8636 37.8788 -6.7252 3.81489 7.59342 -3842 4 49.7597 17.9698 36.6907 -30.5426 -29.286 -11.4073 -3843 6 24.6818 24.2557 40.239 -30.3362 18.6852 9.52233 -3844 4 23.7683 24.4347 40.5809 21.1328 -2.57181 -5.50386 -3845 4 24.791 23.3075 40.3447 2.5826 -1.14956 -5.51696 -3846 6 37.3025 22.0306 23.2304 -1.24857 -1.55203 26.5345 -3847 4 37.0034 21.8174 24.1364 -3.77965 7.42086 -11.5868 -3848 4 37.7677 21.2337 22.9852 8.84969 -1.31238 -13.2672 -3849 6 48.4163 40.4951 28.9695 -6.68628 11.813 -16.9736 -3850 4 49.0084 41.2243 28.7075 -10.6266 -4.31108 -6.63999 -3851 4 47.6767 40.479 28.3098 12.2088 -0.876211 11.6705 -3852 6 24.8524 8.74511 16.566 -5.47802 -1.24744 16.6444 -3853 4 25.3154 9.32041 17.1898 2.58295 -0.80606 -7.28092 -3854 4 25.3735 7.93816 16.4942 1.51819 -5.71343 -7.74972 -3855 6 19.2312 23.0154 32.4581 7.29767 -10.2486 -2.08042 -3856 4 18.4295 23.4489 32.1618 3.75321 4.57429 -6.83594 -3857 4 18.9208 22.4103 33.1253 1.01223 -4.21105 8.69504 -3858 6 3.33807 21.6805 22.4551 -46.3933 -7.60477 16.0737 -3859 4 2.65604 22.1286 23.0335 23.3212 -20.9163 -13.0515 -3860 4 4.02869 22.318 22.3903 27.1551 13.0827 -5.07429 -3861 6 10.2258 20.3371 12.829 -8.54969 -20.6717 -8.68144 -3862 4 9.56384 20.8338 13.3253 4.28314 2.73019 -3.94148 -3863 4 9.70568 19.6401 12.367 8.3544 15.6282 9.01344 -3864 6 9.53393 0.668964 25.3385 8.23748 17.1946 -9.08311 -3865 4 10.3992 0.538209 25.8183 -20.1327 16.9559 -17.4439 -3866 4 9.57635 1.38514 24.6117 12.9812 -33.3008 29.4344 -3867 6 10.6624 40.712 9.64369 -16.6479 -8.09828 -30.6343 -3868 4 10.6692 41.3905 10.303 1.51816 10.4523 18.0663 -3869 4 9.97599 41.0031 8.99599 12.0328 -9.66263 16.6565 -3870 6 46.359 25.2248 32.6769 -14.7838 37.2607 37.796 -3871 4 46.1367 26.0735 33.2154 13.6855 -48.6436 -31.9122 -3872 4 46.6282 25.5659 31.8216 4.36769 -3.83668 -6.22015 -3873 6 38.9431 3.2028 23.1016 18.0409 -17.6687 24.963 -3874 4 38.0396 3.32435 22.9005 -28.138 13.963 -19.732 -3875 4 38.8834 2.64883 23.9052 13.1186 5.8311 -6.82495 -3876 6 33.334 23.6417 36.8871 -1.6197 -14.346 14.9842 -3877 4 32.7695 23.6175 37.7211 18.6046 10.6207 -30.6843 -3878 4 33.5528 24.5621 36.6745 -4.59115 1.63353 1.59233 -3879 6 51.9355 33.3272 25.435 24.4931 61.1901 -39.0042 -3880 4 51.4286 33.1494 26.1943 -20.5556 -13.8295 37.3068 -3881 4 51.9313 34.3506 25.3627 -2.33157 -52.0679 -5.38276 -3882 6 32.1777 25.0215 33.1655 -4.40266 21.2191 -9.05445 -3883 4 32.7541 25.8194 33.0841 -10.7751 -17.7804 3.95932 -3884 4 31.2703 25.3891 33.0319 13.5135 -10.8842 0.697404 -3885 6 51.2858 27.7149 39.5023 -29.438 -28.7732 26.1015 -3886 4 51.6029 27.7352 38.6212 16.0201 9.86215 -30.6452 -3887 4 51.6337 28.456 39.976 12.6328 17.4546 7.30145 -3888 6 34.2938 28.319 17.2582 8.1769 -6.30709 4.0332 -3889 4 33.5147 28.7567 16.9609 -27.2201 13.5182 -7.119 -3890 4 34.2215 28.3851 18.2119 5.48963 -10.3892 10.8325 -3891 6 36.9125 8.03614 37.8626 31.6258 41.6511 37.5008 -3892 4 37.1772 8.64874 37.1722 -6.23292 -16.4311 -22.0997 -3893 4 37.3691 8.52088 38.6203 -30.9712 -36.3395 -15.9768 -3894 6 34.8794 19.4073 6.12479 12.5531 6.66298 1.29528 -3895 4 34.0931 18.8687 6.15723 -9.84615 -2.81902 0.903663 -3896 4 34.5874 20.3343 6.07707 7.75337 -1.04832 -3.72421 -3897 6 52.9388 9.46792 7.82791 49.0384 32.8563 -49.3294 -3898 4 52.8922 10.1625 7.06425 -6.6048 -31.3865 41.9454 -3899 4 52.145 9.34409 8.30569 -37.6802 7.72308 13.142 -3900 6 36.3078 5.4787 38.9756 -59.3492 -35.3574 -23.3076 -3901 4 36.7604 5.44249 39.7856 34.2456 7.44664 27.0781 -3902 4 36.4713 6.28646 38.5283 19.3627 32.146 -13.2298 -3903 6 10.0102 14.4476 13.47 7.45507 32.9986 11.9551 -3904 4 10.2267 15.3574 13.7991 -6.33005 -21.0964 -5.42394 -3905 4 9.26267 14.5991 12.8847 -7.70629 -5.78085 -0.713961 -3906 6 17.2158 24.3617 39.7859 1.82925 -26.4802 17.5225 -3907 4 16.9252 25.2477 39.6578 -10.2532 23.1813 -8.78866 -3908 4 16.8659 24.1409 40.6742 12.3143 -2.49802 -8.33055 -3909 6 49.0708 32.5605 7.76617 4.98775 -19.9892 12.4117 -3910 4 48.2488 33.0406 7.85919 -4.66971 4.38963 1.84033 -3911 4 49.5854 32.9586 7.08254 9.03816 10.9607 -18.1455 -3912 6 44.8772 24.3958 5.47001 55.4245 15.4507 -4.26518 -3913 4 44.8128 24.5742 6.41303 -16.1158 -0.171295 7.10823 -3914 4 44.0866 23.9971 5.17679 -42.0653 -18.1716 -4.3799 -3915 6 37.3106 29.1913 32.8596 13.2918 -7.82588 25.4298 -3916 4 36.7195 29.353 33.61 10.148 2.43022 -0.346483 -3917 4 36.7915 29.3572 32.1043 -27.5405 3.64351 -29.7293 -3918 6 0.903259 24.8209 21.2384 21.1637 23.8586 -12.5999 -3919 4 1.07153 25.1845 20.3306 -6.36458 -4.90686 24.2304 -3920 4 1.48599 25.3539 21.839 -15.2813 -16.355 -7.82064 -3921 6 53.0335 2.20305 13.0061 -8.76459 0.917863 -30.1717 -3922 4 52.7178 1.83592 13.8181 -1.16689 -4.66991 20.3458 -3923 4 53.3973 3.07458 13.1779 4.70755 1.41814 13.7418 -3924 6 24.3073 33.9788 13.9425 26.9643 -19.8352 3.53447 -3925 4 23.8166 33.1535 14.1304 2.48225 11.7572 -2.64876 -3926 4 25.2622 33.8278 14.204 -36.1259 9.29052 -3.07765 -3927 6 40.931 19.3008 0.314297 -22.2267 40.7784 4.53314 -3928 4 41.073 18.3876 0.266006 15.5735 -49.6404 -1.39225 -3929 4 41.7685 19.7545 0.415523 11.1161 2.19254 -0.550631 -3930 6 38.3131 32.0321 21.5909 -11.558 27.6654 -12.3629 -3931 4 37.7152 31.3901 21.181 3.54948 -0.803384 -4.61225 -3932 4 38.0485 32.9451 21.2634 6.02672 -33.9485 15.0266 -3933 6 42.3093 34.9988 16.9782 -31.0886 21.3467 -4.04435 -3934 4 41.4322 34.9872 17.4259 23.1708 5.16072 -1.2535 -3935 4 42.7209 34.172 17.1456 10.0707 -23.8474 2.85212 -3936 6 19.5555 24.3301 21.9337 4.81064 -45.312 41.7565 -3937 4 19.0503 23.5208 22.2695 18.6897 32.4519 -16.5084 -3938 4 18.9494 24.7901 21.383 -21.2783 9.24005 -16.3011 -3939 6 21.0765 3.08453 14.9497 18.8565 6.62045 0.482113 -3940 4 21.9827 3.42458 15.1377 -20.4059 -2.71097 -2.70114 -3941 4 21.0593 2.94323 13.9894 -7.00518 -5.35814 1.95693 -3942 6 16.4422 12.1477 28.531 -0.750899 4.00912 3.87665 -3943 4 16.9503 12.6102 29.2147 -1.62139 -0.392447 -5.94721 -3944 4 15.8278 12.7952 28.1633 1.40376 -4.03425 1.22377 -3945 6 29.5501 4.7113 21.752 31.6763 -19.7408 -11.7502 -3946 4 29.7575 3.81476 21.3864 -8.62397 20.1371 9.94028 -3947 4 28.6767 4.97136 21.4837 -14.307 1.15287 -5.34284 -3948 6 47.4015 12.0887 13.4082 -20.234 -20.0739 19.2385 -3949 4 46.7896 12.1748 12.658 5.24956 2.33261 8.08179 -3950 4 46.8763 11.6307 14.143 25.8489 23.9178 -32.3489 -3951 6 26.4368 0.034911 5.58657 -64.7941 -10.5287 17.818 -3952 4 25.4579 0.386547 5.64311 57.7785 -5.53424 -8.5606 -3953 4 26.2825 41.0177 5.90114 11.1228 18.2746 -10.9356 -3954 6 20.8239 34.8091 41.3451 3.02448 22.7042 23.7072 -3955 4 20.8848 35.7307 41.7064 -1.83719 -23.2001 -12.5561 -3956 4 21.5135 34.3024 41.8142 -0.435548 5.34794 -5.15218 -3957 6 12.6914 17.4806 1.38079 -1.22179 11.8948 19.0955 -3958 4 12.6924 17.2614 2.32235 1.20892 0.120609 -3.36771 -3959 4 12.6119 16.652 0.923905 -0.609755 -13.5185 -16.0456 -3960 6 30.0783 10.198 8.41195 2.12134 -1.25171 -25.3141 -3961 4 29.3533 10.7626 8.0964 5.01977 -3.23694 0.534487 -3962 4 29.9182 10.0601 9.33268 -3.94599 -2.47727 24.1034 -3963 6 36.3506 5.44781 23.9083 -0.549638 14.3818 20.7021 -3964 4 36.0156 6.32048 23.6328 6.62881 -2.58855 0.476976 -3965 4 37.0027 5.63115 24.6267 -8.58297 -8.41851 -13.9364 -3966 6 34.0301 39.9488 19.4964 -23.0399 -20.8249 18.5921 -3967 4 34.456 39.4415 20.2152 6.93565 15.6495 -14.2212 -3968 4 34.6348 40.5483 19.0534 11.5364 2.12704 2.14354 -3969 6 25.0981 29.0133 17.0022 63.4673 53.603 -24.6749 -3970 4 24.4066 28.4545 17.2066 -49.3728 -47.1307 14.2315 -3971 4 24.9323 29.3693 16.11 -4.01222 -10.2038 10.3173 -3972 6 28.4991 21.3215 6.5284 30.3134 51.3135 12.4116 -3973 4 28.073 21.8131 5.82363 -12.0684 -17.0718 -17.6117 -3974 4 29.0439 22.0969 6.88435 -18.1485 -38.7813 5.23359 -3975 6 18.6639 26.1486 0.434559 17.278 41.4043 -10.2832 -3976 4 18.2934 25.3073 0.618971 -26.4426 -25.2614 5.85754 -3977 4 18.1648 26.8598 0.892557 2.28699 -17.4047 3.2853 -3978 6 10.9881 29.7025 15.4563 -76.0882 18.6105 19.9394 -3979 4 11.66 29.3744 14.945 58.6215 -25.2203 -34.7363 -3980 4 11.3165 30.0451 16.2682 18.0847 5.23212 20.5617 -3981 6 33.4842 3.75768 10.5858 0.636803 10.5574 28.6939 -3982 4 33.4734 3.50079 11.5612 -0.522502 1.02567 -36.066 -3983 4 33.5593 4.73652 10.6 -0.068286 -14.4363 0.33475 -3984 6 12.2823 28.8038 23.0281 11.3775 -6.29424 6.84391 -3985 4 12.7596 29.6284 22.9364 3.04418 8.52871 -1.54448 -3986 4 11.6562 28.9633 23.7417 -11.9653 1.92572 -6.97409 -3987 6 13.0879 10.2853 41.0171 -47.2786 6.02767 7.69694 -3988 4 13.8008 10.0588 41.5617 38.8858 -12.6991 24.323 -3989 4 13.445 10.533 40.1929 12.5253 9.31307 -31.237 -3990 6 45.8279 29.9763 22.3517 -19.0059 -47.3471 -0.794771 -3991 4 46.3385 30.6632 22.7121 22.9496 35.5749 11.5915 -3992 4 46.1736 29.1608 22.8005 -10.4716 15.4455 -15.9284 -3993 6 41.5587 12.1258 14.79 16.8952 2.46742 -19.497 -3994 4 40.8127 12.0778 15.3866 -8.88903 2.06539 11.4921 -3995 4 41.9001 13.025 14.8368 0.886253 5.83282 4.44761 -3996 6 18.1774 7.21532 24.17 -10.7079 71.0597 15.5191 -3997 4 17.3895 7.85304 24.2309 32.278 -29.8877 -8.26822 -3998 4 17.8432 6.3671 24.0218 -31.5603 -50.1252 -1.23769 -3999 6 1.46617 28.3087 7.5822 17.4051 32.8243 -18.4272 -4000 4 0.972435 27.5241 7.77639 -23.983 -7.56132 -3.64975 -4001 4 0.919057 29.0368 7.16413 8.17263 -22.6878 11.3207 -4002 6 11.3257 12.3178 24.0505 6.50608 36.5044 21.7543 -4003 4 11.787 12.9182 24.6663 -15.142 9.53056 -9.69028 -4004 4 11.7144 11.5384 24.3755 9.90684 -45.3393 2.97811 -4005 6 17.9727 40.4585 24.4268 -2.1753 13.4943 43.6914 -4006 4 18.2079 40.9973 23.706 15.3173 17.1897 -35.5256 -4007 4 17.8423 41.1404 25.131 2.16294 -27.9915 -10.5346 -4008 6 25.5983 7.44259 34.0136 19.3716 5.77393 -21.6373 -4009 4 25.8935 7.97324 33.2232 -7.88236 -13.8451 20.6491 -4010 4 24.6626 7.5793 34.1612 -12.3217 5.75259 0.6842 -4011 6 16.9533 36.3934 7.79695 -14.7733 -58.972 -15.2131 -4012 4 16.1509 35.7821 7.92089 32.5681 38.8119 0.0631702 -4013 4 16.873 37.2333 8.21975 -10.866 19.0251 14.3825 -4014 6 12.4478 39.1676 36.8063 -58.2746 -19.2691 -7.14825 -4015 4 13.2621 39.5728 37.0444 24.763 -2.90148 -1.94315 -4016 4 12.5678 38.2718 36.42 14.2903 21.5885 11.3364 -4017 6 23.4428 1.91286 37.7232 -9.22102 6.32267 -24.8838 -4018 4 22.7837 1.60923 37.0782 3.11058 2.78987 13.6287 -4019 4 23.6923 2.7833 37.361 6.97145 -2.92816 9.87668 -4020 6 26.6131 34.8527 39.0629 -0.358317 22.46 -5.08852 -4021 4 25.9211 35.0251 39.7209 4.63868 -0.642547 -8.45736 -4022 4 26.6245 35.623 38.4346 -11.8568 -25.3624 13.8384 -4023 6 44.7506 35.5772 23.1679 10.7298 -18.8811 -26.4233 -4024 4 44.6498 36.2622 23.8111 -7.39072 22.4611 10.5052 -4025 4 44.899 35.9413 22.2637 -2.27133 -5.1907 16.9936 -4026 6 34.6136 35.4178 26.71 -15.9342 1.46423 13.2724 -4027 4 33.7739 35.201 27.1682 15.3038 9.13482 -13.5788 -4028 4 35.2424 35.4667 27.4557 -1.55634 5.60609 -12.3698 -4029 6 12.4253 29.8367 9.37257 6.8074 7.71813 14.8361 -4030 4 12.5954 30.1793 10.279 -1.64518 -2.79843 -17.3301 -4031 4 11.9756 30.5342 8.87466 -2.55144 0.413422 5.70549 -4032 6 46.4578 41.3781 16.9525 -1.71223 -15.9012 -6.63524 -4033 4 46.309 0.164546 17.5847 2.66821 13.6546 8.2853 -4034 4 46.3887 41.8168 16.0911 -0.805017 -2.71613 2.08401 -4035 6 39.1753 31.0467 24.0118 -3.10819 6.08124 -21.6124 -4036 4 39.1065 31.2708 23.0301 -7.23524 -5.82233 36.9271 -4037 4 38.2867 31.0608 24.4123 9.52041 3.88051 -10.8568 -4038 6 40.5402 9.7597 28.9847 14.8037 -28.2595 -25.194 -4039 4 40.7176 8.78836 28.9335 -4.00485 22.4893 3.39032 -4040 4 39.9733 9.89103 29.7293 -9.65138 5.58475 19.0645 -4041 6 33.5593 11.9211 22.729 -1.15717 -3.69298 36.7387 -4042 4 33.4631 12.1387 21.8005 -14.8881 8.7456 -3.74916 -4043 4 32.9393 12.4796 23.2922 26.8098 -15.4098 -27.756 -4044 6 29.0159 38.7519 2.46278 27.6721 -15.5988 -40.3681 -4045 4 29.1586 39.6546 2.1748 2.74048 3.67355 2.54153 -4046 4 28.5501 38.8453 3.26351 -22.211 -0.421087 25.3577 -4047 6 51.2833 6.14739 28.3043 6.24107 -1.78447 -16.8419 -4048 4 51.6927 5.30788 28.0231 -4.79213 3.01935 13.8596 -4049 4 51.5671 6.73798 27.5888 -1.89698 -2.53529 10.4249 -4050 6 34.1064 16.6123 14.042 -37.0155 -16.4066 -7.07731 -4051 4 33.9904 17.5439 13.9588 -10.6946 23.5239 -0.125603 -4052 4 35.0244 16.4872 14.0391 48.662 -2.86898 -0.118382 -4053 6 34.4321 40.0645 7.48859 13.9518 5.57425 38.6209 -4054 4 34.6497 40.8416 6.93548 -15.3832 -25.9537 -5.407 -4055 4 34.0868 39.3056 7.01264 2.49953 7.17747 -18.8692 -4056 6 42.5297 22.9808 4.38266 2.56422 12.7755 -29.8183 -4057 4 42.7079 23.1404 3.43503 2.07895 -8.20356 9.72626 -4058 4 41.6007 23.2438 4.43282 3.68115 -1.88729 13.9368 -4059 6 1.41725 11.7089 10.583 40.9585 72.4956 7.82458 -4060 4 2.29602 11.7947 10.1149 -31.3121 -19.1762 2.07637 -4061 4 1.32217 12.6809 10.8959 0.250133 -47.8987 -12.0904 -4062 6 10.0222 17.1523 40.4009 -13.9984 -42.4532 23.0969 -4063 4 9.09922 16.7881 40.4362 25.3227 17.9847 -3.64852 -4064 4 10.5566 16.4623 40.9043 -11.7978 28.1532 -20.1855 -4065 6 26.3773 1.16785 23.7951 0.897687 17.1036 -20.4546 -4066 4 26.2949 1.59753 22.8926 6.72339 -10.2637 31.134 -4067 4 26.8106 1.83522 24.3632 0.404944 -5.36666 -8.232 -4068 6 4.47728 16.2319 39.0174 38.9165 -19.7518 -18.3291 -4069 4 4.60126 15.8787 38.0926 -3.95383 11.2541 23.7603 -4070 4 5.37849 16.1152 39.4714 -36.6531 9.54225 -13.0705 -4071 6 24.3645 39.8454 14.0862 11.6717 18.512 -7.42816 -4072 4 24.2179 40.7168 13.6655 -1.51261 -13.0973 5.973 -4073 4 25.144 39.5095 13.6466 2.38152 -7.3908 -1.6645 -4074 6 19.9724 19.004 10.1294 8.87966 -14.5095 2.71373 -4075 4 19.0999 19.3915 10.2782 -1.93643 -3.06257 7.63815 -4076 4 20.1403 18.2899 10.8137 -9.49435 28.7308 -18.8504 -4077 6 45.2455 15.0555 25.2985 9.44949 25.5865 29.6023 -4078 4 44.5225 15.6147 25.6238 -9.11717 -2.3226 -13.4673 -4079 4 44.9162 14.4027 24.6993 -17.0358 -18.2103 -14.0354 -4080 6 47.6513 32.9537 29.9733 -3.02769 -8.48031 15.1317 -4081 4 47.7848 32.4488 30.7976 5.01558 10.2706 -8.76515 -4082 4 46.6987 33.0693 29.9097 -5.02316 -0.316015 -4.02449 -4083 6 9.31033 14.1561 35.6305 -9.15199 13.4931 14.7277 -4084 4 10.2186 13.9515 35.3646 1.69372 -1.68405 10.862 -4085 4 9.25805 14.5533 36.5394 11.2175 -11.577 -22.5615 -4086 6 0.560208 28.7354 32.128 -23.2584 38.0618 20.8665 -4087 4 0.439761 29.1616 31.2639 2.79308 -8.58991 0.800302 -4088 4 0.67028 27.8063 31.9961 10.5465 -16.7679 -9.91325 -4089 6 26.1282 14.1993 40.8411 59.6454 -38.6249 5.43898 -4090 4 26.432 13.4524 41.4491 -20.3805 31.5142 -12.0858 -4091 4 25.201 14.2926 40.8644 -35.6636 2.31432 7.08225 -4092 6 38.0409 1.72795 37.3461 -15.986 9.3487 3.27435 -4093 4 38.337 1.77003 36.4219 -6.4212 0.733726 8.60438 -4094 4 37.1869 2.24333 37.3721 25.3175 -16.9011 -0.126137 -4095 6 43.391 21.0055 0.385428 11.1435 51.3868 10.1231 -4096 4 43.3728 21.9356 0.739051 -22.7765 -27.5137 5.23027 -4097 4 44.2566 21.1078 41.893 4.66373 -25.0138 -11.6612 -4098 6 29.7339 12.3948 17.084 15.7249 11.0657 13.1734 -4099 4 30.3928 12.9555 17.5239 -4.04604 16.1495 -27.1654 -4100 4 29.6387 11.801 17.8166 -19.321 -23.8097 4.84602 -4101 6 21.0831 10.9976 35.6454 20.8751 25.9078 26.8503 -4102 4 20.9144 11.9356 35.5 -2.5465 -0.914036 2.40284 -4103 4 20.6111 10.5739 34.9651 -17.7649 -25.2648 -31.6786 -4104 6 24.3635 22.1336 17.0651 -49.7832 5.03398 -16.9936 -4105 4 24.7447 22.8357 16.5516 14.0354 11.6369 -2.31656 -4106 4 25.0369 21.6158 17.4366 35.7007 -17.2122 18.4164 -4107 6 44.2543 9.63808 6.15039 20.313 -11.2139 14.5913 -4108 4 44.7688 9.46356 5.36091 -1.47318 -0.699349 -10.0319 -4109 4 43.371 9.9028 5.92157 -14.9065 6.10764 -5.2575 -4110 6 40.8032 2.87739 6.28666 -13.1289 22.479 10.901 -4111 4 40.3272 3.11809 7.09229 2.74106 -9.45257 -1.64817 -4112 4 40.5645 3.60702 5.69531 8.12536 -6.41414 -12.3146 -4113 6 23.4888 29.7691 25.1996 -20.8577 -7.3866 7.78845 -4114 4 23.0356 30.0691 24.4173 -11.1707 -5.96106 -7.76576 -4115 4 24.1981 30.3761 25.2406 38.2449 14.7306 0.541559 -4116 6 45.2336 20.6129 7.48752 -14.5833 -17.9538 -3.88696 -4117 4 44.4222 20.5961 6.94177 10.1673 3.83834 -0.615812 -4118 4 45.4226 19.6724 7.65027 4.1577 11.2609 0.378107 -4119 6 44.1804 26.5848 16.646 -7.77871 8.0927 60.0057 -4120 4 44.4497 26.5291 15.7549 9.82788 -17.3929 -39.3829 -4121 4 43.995 25.6977 17.0036 0.668911 -2.30329 -14.751 -4122 6 23.5902 27.0659 18.0913 -39.7013 -11.93 7.95298 -4123 4 23.083 26.2674 17.8176 19.208 11.4009 -9.44785 -4124 4 22.9184 27.4761 18.6801 25.6051 0.00742342 -8.40738 -4125 6 45.1467 16.0991 8.91755 -25.3782 -1.90264 -8.59791 -4126 4 44.1891 15.9425 8.7462 16.1978 6.4454 1.17339 -4127 4 45.2138 16.0078 9.87006 7.52298 -2.6657 10.2407 -4128 6 39.0203 15.1531 5.23259 28.6956 12.0263 -26.8074 -4129 4 39.7994 15.5772 4.7964 -10.087 -12.1112 6.39319 -4130 4 38.3368 15.7917 5.08662 -19.5574 10.6606 0.980846 -4131 6 40.468 4.77411 20.0927 -27.3359 -4.798 12.1592 -4132 4 41.2634 4.72652 19.6 29.6653 -1.38796 -18.2664 -4133 4 40.7147 5.23292 20.8909 -0.487482 4.30709 11.6637 -4134 6 35.8395 28.4372 39.9091 -50.8572 -25.335 -8.14583 -4135 4 35.0416 27.8127 39.7761 37.8149 25.8469 12.2999 -4136 4 36.4241 28.1912 39.1903 12.774 -11.5781 0.139918 -4137 6 26.5706 3.57143 2.67715 -46.9093 11.529 -12.2012 -4138 4 26.01 3.47498 1.86726 21.0232 -0.263485 19.1529 -4139 4 25.9795 4.13239 3.25499 25.5536 -16.3527 -3.3314 -4140 6 2.96374 21.6426 17.6806 -14.2306 -5.51577 -4.68338 -4141 4 2.93927 22.2072 18.4518 0.989431 6.72084 9.51867 -4142 4 3.70489 21.9005 17.1296 5.59779 10.8847 0.849605 -4143 6 12.8869 25.0552 25.9401 15.4127 26.4598 -14.83 -4144 4 13.2774 25.9118 25.6194 -5.06291 -21.1213 8.866 -4145 4 12.0842 24.9634 25.4247 -11.7493 -3.09829 -2.0396 -4146 6 41.5869 20.6707 14.1801 -22.4147 -6.05744 0.611169 -4147 4 42.2929 20.1295 13.8255 12.8925 2.43785 -7.39699 -4148 4 41.9118 21.5622 14.3536 8.70683 -8.7017 2.36606 -4149 6 1.26372 39.5934 11.5416 -2.31472 -23.2994 -17.666 -4150 4 1.60499 38.7626 11.0579 -12.721 36.8399 30.164 -4151 4 1.30151 39.4907 12.5143 8.15813 -4.07121 -11.1907 -4152 6 16.0274 39.0089 34.0759 -23.376 3.35378 -54.2756 -4153 4 15.5279 38.2654 33.6809 12.2329 5.59336 21.1278 -4154 4 15.9645 39.6681 33.3256 8.94624 -4.65522 31.8649 -4155 6 20.5749 7.01511 25.5545 -9.93748 22.9073 -1.77669 -4156 4 20.7998 7.9126 25.2373 7.69672 -13.5438 0.480138 -4157 4 19.6147 7.02086 25.4453 1.79337 -5.45304 -5.32881 -4158 6 45.1903 25.5946 39.1745 -26.3826 2.10768 23.1727 -4159 4 45.9078 26.0337 38.7511 23.0136 15.7961 -19.2282 -4160 4 45.315 24.6755 38.9972 4.74877 -22.0383 -3.82349 -4161 6 19.9254 40.1108 28.2935 0.936604 13.13 -6.83142 -4162 4 19.0415 40.3022 27.9603 -1.00367 -13.9734 -0.221352 -4163 4 20.1058 40.9072 28.8104 6.81084 -8.28794 7.10232 -4164 6 26.5025 14.2024 27.3816 7.55525 -11.5245 -39.7478 -4165 4 25.5661 14.1885 27.2241 -23.3405 -0.187867 -1.3667 -4166 4 26.5864 14.6167 28.2174 4.05242 7.69107 36.9512 -4167 6 51.349 25.9455 3.44193 13.1564 1.83251 -14.1309 -4168 4 51.0731 25.276 4.04973 -8.84751 -13.2679 15.0063 -4169 4 51.8098 25.4164 2.75525 -2.9574 19.5765 2.79729 -4170 6 20.1579 26.1269 2.66057 8.08543 -14.232 12.5138 -4171 4 20.4198 25.2285 2.95049 1.99012 13.1431 -7.88687 -4172 4 19.9848 26.1042 1.70984 -1.68704 0.137755 2.48294 -4173 6 3.12857 11.9594 27.2244 18.8731 20.7243 14.7894 -4174 4 2.60719 12.6622 26.8077 5.30838 -2.59233 -3.81502 -4175 4 3.76928 12.4285 27.8301 -19.9135 -11.7573 -12.7739 -4176 6 30.1745 26.3671 4.00755 44.117 -33.7612 35.926 -4177 4 30.7719 25.91 3.40695 8.20711 -11.5121 5.52432 -4178 4 29.6741 26.8182 3.4039 -49.0538 48.0497 -39.0484 -4179 6 19.309 20.6617 30.5327 -6.17305 20.3286 19.7257 -4180 4 19.3357 21.5037 31.0044 -16.2324 -1.53368 2.5841 -4181 4 20.215 20.6027 30.2783 24.1248 -10.9268 -16.9107 -4182 6 13.5428 36.2605 0.333332 15.0011 -10.6689 28.2547 -4183 4 13.9636 37.1467 0.274336 -13.564 -9.3403 -16.0521 -4184 4 12.8146 36.0991 41.6409 -4.77188 14.7057 -15.3617 -4185 6 13.69 21.7667 35.9665 -20.2473 -15.4187 -13.4538 -4186 4 13.4364 21.3658 35.099 7.7487 10.4825 13.8843 -4187 4 14.5406 22.1631 35.8296 17.4857 6.37333 -3.13554 -4188 6 39.4374 1.76506 25.3393 -36.4427 -7.29022 -10.5984 -4189 4 39.9364 2.34528 25.9215 16.7605 -3.08023 1.72977 -4190 4 39.8192 0.8892 25.1573 19.013 15.1682 11.727 -4191 6 18.3049 6.14326 35.8392 -10.8025 -19.5812 3.54688 -4192 4 18.125 5.32611 36.3393 4.50778 0.182671 -16.8727 -4193 4 18.2664 6.78418 36.55 10.3297 13.4079 -7.40032 -4194 6 2.50698 24.635 10.1008 2.82606 57.1639 14.1456 -4195 4 3.34783 24.2504 10.0645 38.9609 -42.7111 -6.9151 -4196 4 2.85647 25.509 10.4424 -34.1939 -15.4438 -5.60802 -4197 6 35.8245 9.94707 1.36321 12.392 22.5458 6.51215 -4198 4 36.2598 10.3662 0.602857 -1.03193 -1.33218 7.37913 -4199 4 36.14 10.4815 2.15194 -8.91958 -29.9524 -28.0328 -4200 6 29.0093 17.9332 41.5934 -7.9582 -11.0366 0.585828 -4201 4 28.5465 17.2289 41.1281 -16.7755 -3.81322 9.83818 -4202 4 29.6221 18.1453 40.9114 24.9254 25.1746 -10.164 -4203 6 46.0106 27.0842 25.8657 -15.8538 -10.6571 1.20957 -4204 4 46.7573 26.8966 26.4316 13.3887 1.52966 8.34957 -4205 4 45.3967 26.3449 26.0537 1.02353 6.85943 -7.5889 -4206 6 28.1115 10.6516 35.9124 -31.4415 -9.81676 -35.067 -4207 4 27.3321 11.0804 35.4953 10.9044 -14.8673 0.927998 -4208 4 28.4149 11.3158 36.4913 19.5717 24.3857 28.0975 -4209 6 25.9462 20.1874 24.7713 21.0981 19.7274 8.06252 -4210 4 26.7479 20.7296 24.6265 -12.3387 -9.71047 -3.27099 -4211 4 25.8934 20.1715 25.7373 -11.4252 -1.9185 3.65337 -4212 6 32.2315 30.2636 10.2038 46.2181 -42.2335 3.06511 -4213 4 32.6954 30.7903 9.55855 -13.4496 21.2522 -10.6663 -4214 4 32.9512 29.5744 10.3289 -28.7668 14.232 9.31608 -4215 6 5.05112 34.4033 23.8133 19.5013 -14.7597 17.0713 -4216 4 5.8904 34.9145 23.8209 -18.4686 -4.57798 -7.44977 -4217 4 4.4328 34.8283 23.2333 -4.78059 12.4432 -11.9709 -4218 6 29.6287 34.9421 23.1129 15.2461 20.4143 1.29823 -4219 4 30.2662 35.203 23.7945 -9.70178 1.77141 2.28452 -4220 4 29.7307 34.0083 23.0447 -4.13429 -24.1479 2.03513 -4221 6 52.1909 25.2296 36.2512 2.86438 -10.6824 22.6831 -4222 4 51.9483 25.3775 37.2028 5.23419 -4.07811 -26.4725 -4223 4 52.3343 24.2634 36.1804 -4.32722 6.81431 1.64545 -4224 6 6.96184 41.26 14.9825 2.80521 -5.8094 -40.534 -4225 4 7.04984 41.0874 15.8994 5.94782 -9.0625 22.8431 -4226 4 7.58542 40.6644 14.4953 -8.6815 16.2518 18.3581 -4227 6 27.6618 39.1341 4.65497 -15.321 -2.42325 19.5764 -4228 4 26.8583 38.6531 4.9607 13.8024 7.31782 -7.34321 -4229 4 28.2878 39.16 5.39008 -5.06496 -7.53921 2.22048 -4230 6 44.4448 15.8874 30.3939 -2.31018 0.103575 -22.4191 -4231 4 43.6353 16.4379 30.2788 15.6665 -12.4266 1.42045 -4232 4 44.7559 15.574 29.5018 -16.8402 11.4423 19.721 -4233 6 27.2939 38.1254 13.0955 15.3768 -40.6351 2.35664 -4234 4 27.6299 37.3572 12.5713 -6.06373 15.2601 5.99839 -4235 4 27.2975 37.7701 14.0147 -10.0522 11.5876 -10.9657 -4236 6 26.6773 32.9794 36.8294 -32.6396 -25.4624 12.1292 -4237 4 27.3491 33.5429 36.5103 30.2383 22.5556 -9.12925 -4238 4 26.1784 33.4868 37.4729 2.39424 7.35453 7.52648 -4239 6 26.3034 28.2003 31.7109 71.1077 16.3155 0.283388 -4240 4 26.8193 28.3341 30.863 -27.929 -6.55919 23.3278 -4241 4 26.9955 28.4613 32.4053 -35.143 -9.24619 -18.2719 -4242 6 49.2075 35.7729 23.3324 -21.4287 30.6035 9.89313 -4243 4 49.7648 36.3085 23.9054 5.92838 -6.84736 -0.0129328 -4244 4 49.7125 35.0813 22.9401 23.5965 -22.3057 -11.2126 -4245 6 44.2384 15.3735 33.5479 -0.546939 -12.4927 -0.897907 -4246 4 44.8734 15.133 32.8785 13.8917 -2.34347 -2.72297 -4247 4 43.5631 15.8174 33.0372 -7.79828 14.1806 -0.143619 -4248 6 16.6415 35.2629 14.0425 -13.711 -12.7272 -22.5016 -4249 4 16.8779 36.1297 14.3524 2.35153 17.3801 14.4176 -4250 4 15.7232 35.3535 13.695 18.4875 1.24889 7.88518 -4251 6 45.2979 21.4768 12.0753 -61.6802 -17.7786 9.36854 -4252 4 45.9745 21.1118 11.5746 47.2025 -15.5682 -31.9287 -4253 4 44.6407 20.7302 12.0307 13.4445 30.1014 15.4365 -4254 6 51.647 5.33893 20.0992 17.3373 6.85256 40.4731 -4255 4 51.8423 5.82757 20.9547 -12.0569 -16.4938 -26.4666 -4256 4 50.8652 5.75336 19.736 -8.70547 10.2387 -6.49138 -4257 6 22.616 27.3068 0.953729 -12.5585 5.72419 11.7926 -4258 4 21.9912 27.9206 1.39427 2.62886 -13.0847 -9.82719 -4259 4 22.9744 27.8285 0.229956 6.91293 3.08187 -2.36887 -4260 6 46.8924 12.1405 22.3241 28.0037 10.4006 6.07885 -4261 4 46.5361 12.6234 21.5839 -13.5229 3.11861 -11.9828 -4262 4 46.2058 11.655 22.757 -25.8682 -9.85748 8.02404 -4263 6 33.7577 5.61095 25.2306 8.81298 -10.6825 9.18366 -4264 4 34.4045 5.06092 24.7535 -5.77276 6.31779 -0.0821136 -4265 4 33.06 5.8369 24.6155 -4.37455 2.20678 -7.03208 -4266 6 44.2424 18.1337 27.2287 35.5912 4.17402 -1.61274 -4267 4 44.1428 18.6708 26.4104 -1.15401 -3.8952 20.8354 -4268 4 45.2041 18.2132 27.495 -32.4507 -0.562547 -10.2772 -4269 6 5.27745 36.9951 29.0779 -48.9341 45.2857 -18.2185 -4270 4 4.83797 37.847 28.7 19.7525 -41.2711 21.6555 -4271 4 6.18662 37.2124 29.1987 31.023 4.60304 7.81739 -4272 6 20.0415 5.02171 38.9415 13.5567 -45.1901 -20.6947 -4273 4 19.673 5.46942 39.6755 -5.65499 20.9205 26.8401 -4274 4 20.3443 4.13258 39.2728 -11.021 23.424 -4.53385 -4275 6 17.9077 2.77821 33.872 -28.7289 7.66476 22.1934 -4276 4 18.5675 3.36618 33.4993 11.2764 5.36232 -3.32863 -4277 4 17.289 3.30252 34.4687 25.3234 -20.0176 -17.8345 -4278 6 5.56252 23.3664 22.3199 23.4646 34.0494 22.6536 -4279 4 6.31266 23.4141 21.6995 -10.6272 -11.1368 -5.13028 -4280 4 5.83055 24.0852 22.9498 -18.4748 -15.0058 -11.9197 -4281 6 12.7366 28.0136 40.0786 16.9267 17.0007 -14.1953 -4282 4 12.7736 28.981 40.2539 2.04889 -13.1204 -10.7842 -4283 4 13.1752 27.8683 39.2015 -12.0592 5.90979 20.7524 -4284 6 50.5208 38.8121 28.4283 -2.96204 -29.3557 2.62021 -4285 4 51.1161 39.4306 28.008 -0.383593 20.3423 -2.32338 -4286 4 49.7133 39.2143 28.7877 7.69194 10.1621 -6.76025 -4287 6 33.551 8.21903 17.8634 -36.1599 -47.4859 45.2019 -4288 4 33.9333 8.85376 17.3385 32.2471 57.3944 -47.1321 -4289 4 33.8604 7.38657 17.5128 5.83122 -9.97324 -0.737685 -4290 6 34.648 34.7105 17.7828 9.01761 -19.7832 -8.77749 -4291 4 35.1788 35.3328 18.2888 -3.00831 8.66808 4.62333 -4292 4 35.2883 34.0014 17.5711 -12.5093 2.94991 -0.39307 -4293 6 40.7261 5.27864 23.3991 8.21105 0.19251 11.4926 -4294 4 41.4259 4.93717 23.9966 -11.2767 2.88733 -17.4667 -4295 4 40.0598 4.58084 23.2941 1.87831 5.06613 5.43463 -4296 6 16.9137 27.769 14.4809 73.6258 -34.7175 -8.82476 -4297 4 16.0667 28.1115 14.4612 -62.8462 32.6704 -2.60496 -4298 4 17.5486 28.5101 14.4313 -15.9271 -1.25076 7.8547 -4299 6 29.0219 14.6595 5.00786 20.8741 -13.5443 13.1138 -4300 4 29.536 13.8229 4.89138 -12.0375 16.0826 3.98067 -4301 4 28.8859 14.7576 5.97494 -2.91261 0.0620574 -16.4413 -4302 6 36.854 17.7325 5.08016 4.48522 -18.3735 -43.8449 -4303 4 36.2168 18.3553 5.39001 -11.7806 18.6728 17.0618 -4304 4 36.8305 17.8608 4.09391 11.7548 -5.76061 25.8999 -4305 6 27.7142 25.5094 34.8662 20.7401 -29.3529 -12.6468 -4306 4 28.3997 25.1535 35.4786 -13.7878 13.2187 -9.69645 -4307 4 27.3728 26.292 35.2699 -5.77421 14.8272 18.3022 -4308 6 24.7481 17.2805 18.0642 -3.31447 -10.4308 -2.46491 -4309 4 25.3087 17.9154 18.5049 2.27957 10.048 8.00722 -4310 4 24.0564 17.0505 18.7104 4.01172 4.3516 -6.8818 -4311 6 30.1789 1.58441 5.83411 4.12275 19.8646 -71.4749 -4312 4 29.4821 1.85802 6.42075 -6.9839 1.28517 8.89789 -4313 4 29.959 2.0434 4.91278 6.77151 -29.6581 61.3265 -4314 6 37.452 25.891 8.43789 -40.1641 -31.4732 50.6902 -4315 4 38.334 25.9927 8.78667 20.6785 -4.95116 -4.15592 -4316 4 36.9881 25.2791 9.14634 19.6253 32.8331 -49.0064 -4317 6 24.7604 7.00734 2.27008 32.0581 9.85747 -12.4546 -4318 4 25.4028 6.31463 2.48931 -5.40489 7.62931 7.6933 -4319 4 23.9158 6.58667 2.26874 -21.5893 -3.78057 4.11792 -4320 6 25.7887 38.8506 10.7619 -30.5475 28.1992 -59.3139 -4321 4 26.3103 38.4194 11.381 38.5207 -12.4255 48.7922 -4322 4 26.1525 39.7259 10.4932 -1.18865 -9.03037 15.3914 -4323 6 0.555207 13.578 28.1388 12.6332 42.7054 11.738 -4324 4 0.341766 12.7807 27.7179 -10.1825 -36.9478 -16.4943 -4325 4 0.413626 13.4435 29.0864 -5.17296 -1.28815 -2.85065 -4326 6 20.4105 17.1191 12.037 -17.9302 -38.4569 -26.5492 -4327 4 20.2295 17.2547 12.9605 -1.34068 5.07474 20.9983 -4328 4 19.8884 16.3005 11.7926 16.4515 20.0565 4.33162 -4329 6 30.9925 7.37797 16.6653 29.7996 22.3073 3.61878 -4330 4 31.2643 7.03844 15.7784 -2.63758 10.9944 17.123 -4331 4 31.7569 7.94595 17.0261 -27.6116 -29.8279 -14.8225 -4332 6 10.2093 5.78517 12.1714 32.5037 6.96704 58.397 -4333 4 10.1014 6.35617 11.4591 -8.08786 32.1119 -50.7901 -4334 4 9.65707 5.06197 12.024 -36.7963 -41.1043 -15.4671 -4335 6 18.4347 31.3493 24.155 3.48135 -6.25246 2.65688 -4336 4 18.4439 30.3878 24.2879 -2.95335 1.71216 0.944019 -4337 4 18.3198 31.7316 25.0273 -3.67252 2.09543 1.27238 -4338 6 27.8948 29.2525 29.2666 2.33504 21.8021 -21.5937 -4339 4 28.3627 29.5914 28.4251 -11.9103 -18.4763 37.4515 -4340 4 28.5196 28.9609 29.9463 14.9294 0.890267 -8.6061 -4341 6 38.3738 15.4456 29.791 12.9945 -28.6313 15.0543 -4342 4 38.0891 14.5036 30.0544 22.1369 39.5396 -7.74746 -4343 4 39.2957 15.632 30.1541 -37.4531 -3.97597 -10.3113 -4344 6 21.7041 34.7992 5.56934 -10.1436 -56.1371 25.2208 -4345 4 21.4621 33.8673 5.89439 16.7439 32.0975 -19.9868 -4346 4 20.9431 35.2741 5.907 -2.46203 13.3807 -4.97838 -4347 6 18.2064 16.8274 1.01093 1.02147 5.09087 9.91972 -4348 4 17.6405 17.264 0.353478 -0.489627 -6.58546 6.49815 -4349 4 17.8529 17.0628 1.89865 0.517006 0.361128 -13.8735 -4350 6 43.5166 18.4972 39.3436 16.5286 13.9247 -42.0759 -4351 4 43.0101 19.1966 39.7112 -21.9319 15.1254 24.622 -4352 4 43.7095 18.933 38.4597 1.00685 -29.3013 20.2287 -4353 6 17.7976 10.0688 35.5434 7.86102 19.599 -20.2005 -4354 4 17.8945 9.40709 36.2105 4.74187 -18.2058 11.3424 -4355 4 18.5459 9.97323 34.9151 -16.2901 -5.18221 9.2364 -4356 6 36.5889 30.5599 29.0828 -33.0481 48.6405 -12.465 -4357 4 36.5132 31.4977 28.7143 1.54088 -37.0728 8.50934 -4358 4 37.4982 30.324 28.9756 25.7485 -11.7594 -3.68806 -4359 6 38.4943 35.9682 10.4222 10.3079 16.2999 40.226 -4360 4 38.6552 36.6966 11.1228 -3.33458 -34.9071 -25.8136 -4361 4 38.3509 35.1294 10.9235 4.16648 17.1849 -3.98913 -4362 6 43.4036 18.8037 34.3607 -18.7725 -42.8138 41.3108 -4363 4 42.9709 18.1893 33.7432 11.3097 10.906 -2.86187 -4364 4 43.2777 18.3171 35.2411 6.94038 29.5352 -30.5758 -4365 6 11.0585 40.2128 6.10885 -15.7783 5.94868 1.16987 -4366 4 11.5965 40.9262 6.45194 10.3679 4.26541 4.32644 -4367 4 10.1443 40.5526 6.13585 6.40705 -5.05479 -5.29954 -4368 6 48.3342 13.7493 24.4707 -3.46168 30.4962 28.8754 -4369 4 47.8576 13.3588 23.754 -13.8134 -6.92474 -20.9085 -4370 4 47.8711 14.5963 24.7134 14.7345 -25.1065 -10.1999 -4371 6 1.47205 25.7712 23.7829 0.184952 23.7651 -2.41746 -4372 4 0.854396 26.4618 23.4919 -3.79407 -11.1699 -2.17794 -4373 4 2.13056 26.3319 24.2122 9.67536 -12.9921 7.11562 -4374 6 20.5856 0.045789 21.1048 4.96875 -22.7073 -7.43464 -4375 4 19.8117 0.249922 21.5931 -19.4423 21.7426 16.1957 -4376 4 20.4519 41.001 21.0443 13.8042 -0.350206 -3.82588 -4377 6 37.6675 12.896 30.7055 18.9575 -14.1068 -43.1025 -4378 4 37.1872 12.5493 29.907 3.14127 2.53034 24.3729 -4379 4 37.0391 13.1763 31.3358 -31.377 6.23238 20.3235 -4380 6 49.4665 17.3801 9.24655 -8.32961 25.946 -15.5009 -4381 4 48.5345 17.665 9.32633 16.3924 -11.5392 1.15372 -4382 4 49.8219 17.9883 8.54454 -1.98957 -21.6031 19.5257 -4383 6 34.3643 5.3502 17.1421 32.952 7.78829 -18.2658 -4384 4 34.6245 5.26975 16.1857 -14.4704 2.64329 20.4158 -4385 4 33.4298 5.20109 17.2262 -20.6176 -11.2241 -0.901893 -4386 6 14.7832 27.6655 0.085624 -10.3553 13.8949 -22.792 -4387 4 14.1034 27.8892 41.3249 2.03342 -11.2849 14.5146 -4388 4 15.1757 28.5319 0.287496 2.39463 -6.00136 9.68974 -4389 6 48.8635 15.5211 20.7504 -7.30397 3.37214 15.1279 -4390 4 49.1252 16.3754 20.4371 0.183023 13.7927 -3.76167 -4391 4 49.1585 14.9241 20.0762 3.93917 -17.6947 -14.7742 -4392 6 23.8074 40.3851 20.3877 -2.3041 21.5375 32.1864 -4393 4 23.5266 40.991 21.1382 8.45078 -18.9812 -28.3519 -4394 4 24.6929 40.0818 20.645 -4.8729 5.63426 -4.96266 -4395 6 35.18 31.4993 13.7142 -38.6695 32.0432 -41.3249 -4396 4 34.2219 31.3119 13.4889 30.0091 9.93153 3.95626 -4397 4 35.4367 30.7845 14.243 12.3636 -35.8089 30.5679 -4398 6 10.9775 9.01115 39.5206 -26.3812 35.8658 -19.2594 -4399 4 10.5557 9.91556 39.5205 15.5031 -28.3669 -8.85108 -4400 4 11.1542 8.87096 40.4393 5.31517 -3.54045 10.232 -4401 6 53.2061 4.88103 16.6049 -20.6689 -12.7794 3.6937 -4402 4 53.6782 5.3887 17.2239 33.7717 25.1716 19.5104 -4403 4 52.5676 4.51498 17.2255 -11.3933 -13.1169 -19.2452 -4404 6 7.83562 33.8039 26.1496 42.0062 50.3869 -17.047 -4405 4 7.62463 34.1533 27.0155 -6.33847 -9.39794 9.82588 -4406 4 8.42034 34.5749 25.7852 -30.6961 -50.8642 6.91563 -4407 6 31.3279 27.9472 6.28298 4.37835 -19.3247 -9.6219 -4408 4 31.922 27.5111 6.93657 -10.4846 5.09347 -11.9486 -4409 4 31.1129 27.3323 5.53276 6.79934 9.76999 15.6259 -4410 6 31.3655 2.17383 41.055 18.9421 -1.98994 34.5993 -4411 4 31.8109 2.17902 0.04034 -17.0754 7.04602 -28.7946 -4412 4 31.2404 1.23747 40.9086 -7.00813 -7.80206 -8.22245 -4413 6 33.7652 4.25739 35.9001 -31.2863 -13.3655 20.8802 -4414 4 34.2485 3.80076 36.6104 5.56552 8.36292 -9.80816 -4415 4 32.8077 4.13792 36.1863 30.7439 3.51509 -16.9094 -4416 6 47.9725 16.0636 29.8584 -12.289 -4.0311 -5.35812 -4417 4 48.7208 16.4163 30.3732 -4.13056 -10.8519 0.408936 -4418 4 47.3533 15.5947 30.4559 16.7379 8.85318 -0.563064 -4419 6 49.3385 10.0935 28.5885 -11.8118 4.56009 -13.0989 -4420 4 48.5886 10.6638 28.8239 3.51911 -4.5157 1.44109 -4421 4 49.3924 10.1159 27.6088 6.69909 -1.91925 15.8757 -4422 6 21.4187 27.7693 29.76 2.80336 -20.4787 -6.37736 -4423 4 21.861 27.2354 30.4624 -7.84738 15.6574 -13.8161 -4424 4 21.1828 28.6282 30.0799 2.10219 20.3695 17.9057 -4425 6 11.6757 39.482 25.8517 13.5538 20.9417 -1.29545 -4426 4 12.2965 38.7786 26.0889 -7.12508 -2.9493 -2.05027 -4427 4 10.8193 39.0846 25.7116 -11.9056 -6.20494 0.0112269 -4428 6 22.9798 39.311 7.85817 -12.7601 -4.86939 -3.04246 -4429 4 22.3059 38.6219 7.95844 1.92638 3.98273 0.136758 -4430 4 22.5772 40.0658 8.31757 9.04497 -1.85468 3.82529 -4431 6 42.5415 35.9278 31.3391 13.0935 -70.9729 -20.1514 -4432 4 42.6447 35.4696 30.4714 -5.52665 5.17936 25.8951 -4433 4 42.5102 36.7973 31.0384 -8.93799 60.9387 2.27408 -4434 6 33.663 14.7412 3.98499 30.4225 -17.693 -39.6888 -4435 4 32.8564 15.2185 4.09596 -24.3526 16.5192 2.50389 -4436 4 33.8944 14.7916 3.00116 -11.9532 1.40502 32.6284 -4437 6 36.697 8.6017 17.5153 18.7294 -29.9333 -4.55465 -4438 4 37.1702 7.95911 16.9159 -11.687 24.5338 13.7544 -4439 4 36.2734 9.25409 16.9543 -7.54123 3.80926 -6.08989 -4440 6 20.8295 32.4146 17.3309 -48.7404 -21.5825 11.0081 -4441 4 20.1664 32.9726 16.9048 10.2664 9.72211 -3.82622 -4442 4 20.2271 31.8015 17.8465 35.2036 12.7196 -8.50107 -4443 6 20.7003 35.3218 14.1083 -3.44914 -18.0461 -19.2112 -4444 4 21.3182 35.5386 13.4099 3.08163 2.90557 -13.4495 -4445 4 20.919 35.9437 14.7754 1.56244 13.5022 22.2067 -4446 6 20.2323 2.51936 40.1651 -9.22326 -14.3688 36.1644 -4447 4 19.7926 2.34354 41.0434 13.5524 6.30823 -28.5037 -4448 4 20.7516 1.7186 40.0171 -1.27786 1.50094 -7.75906 -4449 6 15.0477 14.4672 0.24789 12.9865 -5.55034 -72.7807 -4450 4 15.4827 13.6954 41.6877 -12.87 20.0829 29.6139 -4451 4 15.2186 15.2036 41.5094 -2.93016 -13.2387 23.097 -4452 6 24.8149 37.3373 18.5213 2.43631 -2.68492 27.9859 -4453 4 24.4361 37.9203 17.8611 -0.249038 9.91659 1.71419 -4454 4 24.5604 37.6468 19.4234 0.486379 -6.00228 -23.279 -4455 6 3.16989 27.7944 5.24229 1.80682 -16.6913 61.515 -4456 4 2.664 27.92 6.09489 -0.254446 2.50987 -32.3978 -4457 4 4.0252 27.4816 5.63916 -14.135 1.37322 -28.2843 -4458 6 37.1257 39.0598 36.0573 4.58816 40.5807 23.3296 -4459 4 37.5599 39.5885 36.7783 -22.7086 -1.13864 -22.8071 -4460 4 37.5439 38.2379 36.1828 13.5973 -37.3165 -5.96047 -4461 6 41.3477 16.3672 3.84024 25.8131 6.72768 37.2631 -4462 4 41.4431 17.3182 3.89206 -17.3786 8.01961 -13.1803 -4463 4 42.0046 16.1549 4.54461 -14.0821 -19.2698 -21.0799 -4464 6 15.5755 3.1684 35.3585 1.47298 2.70845 -61.2084 -4465 4 15.1145 3.59171 34.5864 10.479 -16.2188 17.3147 -4466 4 15.2032 3.60881 36.0782 -15.9672 22.7619 40.5269 -4467 6 33.1731 24.2438 7.96729 6.41569 -10.7526 14.1331 -4468 4 33.3408 24.6773 7.1445 11.9115 -7.07525 -26.7187 -4469 4 32.5824 24.8707 8.33408 -19.4303 14.6961 21.7816 -4470 6 35.865 29.7374 15.5979 -29.8607 35.3275 -32.1308 -4471 4 36.7747 29.6672 15.7703 43.701 -12.5229 16.5971 -4472 4 35.3562 29.0371 15.9739 2.56537 -15.478 18.0667 -4473 6 17.5843 36.8354 41.8728 12.1708 -5.57123 -52.5088 -4474 4 18.1833 36.773 0.675699 12.2604 -1.93512 36.5948 -4475 4 18.2359 36.8623 41.125 -21.8566 7.06165 11.6698 -4476 6 26.5622 4.14672 31.1307 -32.6289 -51.1506 -31.7953 -4477 4 27.2582 4.59627 31.5457 41.9615 24.0313 17.3243 -4478 4 26.8928 3.23766 30.8727 -4.86114 29.783 15.5489 -4479 6 31.9552 1.33198 34.4369 -14.3248 -8.90334 35.5546 -4480 4 32.7269 1.15305 34.9944 8.32726 6.02564 -17.2377 -4481 4 31.2642 1.08685 35.0838 -0.545778 4.81468 -20.3916 -4482 6 24.491 14.7534 2.38457 33.2042 -23.9469 17.2683 -4483 4 24.2753 13.9637 2.92779 -7.56186 18.0622 -11.5291 -4484 4 25.4626 14.8414 2.55985 -20.2114 8.54272 -9.97318 -4485 6 25.7566 20.9055 27.5389 -1.15091 7.1508 6.95521 -4486 4 25.459 20.6057 28.4261 8.17968 -1.38894 -17.9407 -4487 4 25.6371 21.8685 27.5748 1.97223 -1.15564 -2.97875 -4488 6 18.1445 40.1527 30.6395 17.3729 -20.3781 15.2884 -4489 4 18.5141 39.2638 30.8544 -10.5973 16.1604 -9.36512 -4490 4 18.9393 40.7073 30.6583 -6.94059 7.54086 -5.9327 -4491 6 46.7889 23.8914 24.5979 7.31075 41.4222 -46.8858 -4492 4 46.2898 24.602 24.0741 10.6002 -32.8666 22.2289 -4493 4 47.4121 23.5287 23.9473 -6.99108 -0.957122 4.26591 -4494 6 45.6201 22.6921 26.5067 -14.1777 -10.0967 -12.8229 -4495 4 46.0372 22.9342 25.6668 -2.41585 -1.26552 16.8561 -4496 4 46.0784 23.1676 27.2003 -0.61408 1.28207 1.11474 -4497 6 20.1006 4.48803 26.6974 -40.8522 40.1383 42.8029 -4498 4 20.2489 5.43817 26.4853 8.37449 -26.4011 -0.951475 -4499 4 20.6602 3.93368 26.2205 34.0606 -24.4352 -38.1565 -4500 6 35.278 26.5864 12.552 0.280065 20.4825 10.9931 -4501 4 35.6728 25.7022 12.4634 2.08478 13.3641 8.87461 -4502 4 35.7774 27.1222 13.2104 -5.20465 -19.6779 -15.4464 -4503 6 3.25879 33.9669 12.2907 -5.01808 -25.4739 5.3677 -4504 4 2.34263 33.6224 12.3201 4.20809 12.7539 -0.381501 -4505 4 3.26735 34.9165 12.3326 -4.58918 17.9212 0.78916 -4506 6 36.6873 1.27899 25.5756 -31.8717 2.25298 32.7844 -4507 4 37.6116 1.37326 25.7779 18.4499 5.6721 -4.77344 -4508 4 36.2122 1.51788 26.4163 6.97172 -2.04149 -25.7728 -4509 6 16.8705 4.65685 24.0413 -35.5309 2.76318 -23.9776 -4510 4 15.8575 4.70434 23.9217 47.0687 -0.0954558 1.21401 -4511 4 17.247 4.33879 23.186 -5.50277 -2.28941 17.9023 -4512 6 39.6565 15.0715 7.80572 25.6093 19.6796 32.1194 -4513 4 39.2854 14.2576 8.13712 -9.42359 -13.1845 -9.18942 -4514 4 39.3628 15.2517 6.91527 -5.26665 -12.4192 -5.15573 -4515 6 9.97948 20.1659 2.91877 -9.38613 14.9664 11.2777 -4516 4 9.63877 20.6452 2.15027 4.12295 -11.9706 -3.67253 -4517 4 9.85969 19.2106 2.80597 1.71997 13.0916 -4.74013 -4518 6 23.4135 4.6314 15.2717 1.19087 -47.3757 24.1847 -4519 4 23.6596 4.57091 14.3636 3.27412 12.4021 -25.8415 -4520 4 23.0767 5.481 15.4712 -5.64379 31.4202 -0.243197 -4521 6 23.5143 41.6409 17.9193 15.1077 8.25095 -6.6202 -4522 4 23.8837 41.2632 18.7444 -17.9015 4.85421 -1.14363 -4523 4 22.6477 0.129763 18.1032 2.89941 -5.9973 3.37217 -4524 6 30.9257 4.8197 1.33225 52.4556 82.2644 21.8498 -4525 4 30.6067 4.04082 1.0087 -28.5575 -73.6424 -29.1188 -4526 4 31.8008 4.99709 0.898826 -20.2281 -12.9509 7.44496 -4527 6 29.2107 33.7595 18.6102 73.0072 -21.2941 -2.29721 -4528 4 30.2072 34.0216 18.5444 -47.9733 -6.17517 5.28057 -4529 4 28.7323 34.5281 18.37 -21.0864 31.3556 1.11974 -4530 6 23.1159 16.7161 3.6681 15.0693 -22.2232 4.2808 -4531 4 23.7494 16.3853 2.99745 -15.1451 3.0429 8.25243 -4532 4 23.0882 17.666 3.59926 -2.15966 11.8771 -4.335 -4533 6 34.9011 26.7664 31.7501 -1.76717 8.52767 -40.8429 -4534 4 35.037 27.6398 31.3273 1.29043 -2.59798 26.5044 -4535 4 34.999 26.223 30.9552 -0.698038 -3.54606 8.98008 -4536 6 7.10213 40.7731 20.9713 24.4432 1.2064 -5.23395 -4537 4 6.57619 40.3882 20.2802 -20.054 -4.79313 -9.64846 -4538 4 7.95521 40.8692 20.51 0.818491 4.17448 7.60026 -4539 6 52.4557 9.69054 11.9333 -13.8891 -19.4181 -13.3487 -4540 4 52.1298 8.88818 11.4535 9.48574 25.0976 13.8313 -4541 4 53.1611 10.0725 11.3936 -7.122 -1.8527 1.23238 -4542 6 12.0235 32.7598 27.7442 3.70099 -7.78602 -3.89203 -4543 4 11.3626 32.1501 27.3892 -5.86407 9.3821 3.02313 -4544 4 12.7405 32.6461 27.1218 9.18069 3.19616 2.31322 -4545 6 15.7918 18.546 0.850378 10.8461 -1.95532 -11.5883 -4546 4 16.438 18.9813 1.41668 1.29405 -2.87095 0.147979 -4547 4 14.9753 18.6242 1.3119 -21.1882 -0.0291689 9.92309 -4548 6 30.9967 13.9378 7.42939 11.475 1.61738 -44.5395 -4549 4 31.0432 13.5913 6.48715 -7.7997 1.97415 36.5778 -4550 4 31.6719 14.6391 7.43931 -7.46887 -7.66354 10.6483 -4551 6 23.9383 39.564 3.55488 34.3001 -22.0749 -10.0269 -4552 4 24.3437 38.8163 4.07249 -17.2972 16.8542 -11.2744 -4553 4 24.6493 39.7352 2.88999 -19.8697 7.819 10.5959 -4554 6 53.2452 13.9576 2.00229 -14.7116 -5.90049 -8.44118 -4555 4 54.0493 14.3984 2.24709 19.6807 0.169927 9.22775 -4556 4 52.9645 14.4205 1.20429 2.95034 -7.59818 -1.70329 -4557 6 29.4557 26.4275 7.80964 12.1022 6.02758 -9.79702 -4558 4 29.9353 26.7368 7.00545 -17.6775 -4.91001 19.2628 -4559 4 28.525 26.2807 7.58748 -5.08244 6.84096 -3.37299 -4560 6 24.6247 23.6022 31.0889 -22.8452 23.3962 -39.3716 -4561 4 23.7242 23.1866 30.9343 31.0198 16.8155 5.56769 -4562 4 24.7802 24.3072 30.3632 -7.32447 -41.3429 34.091 -4563 6 33.6649 19.3163 40.5091 -6.65541 -1.27585 7.81728 -4564 4 33.8354 18.657 41.2044 -1.67667 1.74775 -3.87809 -4565 4 34.3105 19.1562 39.8145 2.0445 4.20075 -4.1701 -4566 6 0.559384 35.9874 14.2134 5.8565 -19.6842 -1.82955 -4567 4 1.23941 35.9463 14.8996 -3.202 15.0395 2.84586 -4568 4 0.030681 36.7785 14.2979 -4.01885 14.7851 6.49139 -4569 6 7.05661 12.759 15.7779 -22.8667 -6.52104 17.6379 -4570 4 6.34583 12.5966 16.4564 20.9558 0.33122 -21.552 -4571 4 6.91757 12.0848 15.0954 -2.34629 3.44815 6.08752 -4572 6 7.88282 3.87818 22.4173 5.89555 -44.5054 15.1514 -4573 4 7.49019 4.56914 21.9267 -7.80716 26.896 -25.5563 -4574 4 7.61791 3.03791 21.9647 5.08594 18.6769 15.1101 -4575 6 50.7471 32.0888 16.2401 1.83727 42.1646 -7.06137 -4576 4 49.8752 31.8312 16.5285 -7.29916 -4.21179 -0.512004 -4577 4 50.6362 33.057 15.9791 5.96194 -37.4522 8.78354 -4578 6 15.303 18.2089 30.059 10.7923 -22.0796 25.2673 -4579 4 14.9011 18.5061 29.2675 -14.0638 14.0876 -27.3921 -4580 4 14.9173 17.3208 30.1974 9.34767 8.93092 3.04247 -4581 6 36.7231 25.4597 33.3812 -54.2725 16.2506 -34.9161 -4582 4 35.9173 25.838 32.8237 55.5216 -11.0114 39.6871 -4583 4 36.747 24.5432 33.1027 5.79642 -6.85026 5.14009 -4584 6 16.5358 21.8507 20.2615 -17.2006 3.10996 -10.5852 -4585 4 16.5318 20.9271 19.9881 4.62491 -6.39719 -1.16283 -4586 4 16.2171 22.3466 19.4835 8.40466 -0.269645 8.83911 -4587 6 44.2784 3.11614 30.075 -4.29151 -10.9085 31.9498 -4588 4 44.2908 2.23086 29.7056 -5.3385 -9.83615 -1.81045 -4589 4 44.5205 3.68982 29.3775 9.49019 22.102 -29.428 -4590 6 51.0822 14.1295 27.7742 -18.732 -33.3382 -1.30318 -4591 4 51.215 15.0658 27.7997 -1.99026 24.8352 -0.164216 -4592 4 50.1181 13.9695 27.6298 18.0185 9.91077 0.913588 -4593 6 54.1414 15.8836 27.1251 18.1892 -50.717 -21.9912 -4594 4 54.5758 14.9905 27.2793 -7.90108 34.3346 13.352 -4595 4 53.8259 15.7459 26.2068 -12.5208 17.6482 15.4671 -4596 6 26.7107 15.1629 34.529 26.3006 32.6175 -12.2305 -4597 4 26.7089 16.144 34.4655 -8.86078 -18.0829 7.52702 -4598 4 27.5163 14.9973 34.009 -10.4907 -11.0891 -0.654257 -4599 6 34.6699 2.22267 27.4725 27.1341 -12.2799 29.337 -4600 4 34.3153 1.93716 28.3227 7.08088 3.88889 7.09202 -4601 4 33.8991 2.25298 26.9555 -28.541 9.30381 -28.496 -4602 6 36.3083 17.6409 40.3953 7.68303 1.60807 9.57574 -4603 4 35.716 17.1791 39.8253 -12.5236 -4.37947 -14.4862 -4604 4 36.6569 16.9265 40.9504 1.18426 15.263 2.6664 -4605 6 26.2972 0.194896 33.0957 0.945324 -1.75644 -10.1569 -4606 4 26.0926 0.771392 33.8475 -8.68516 2.0119 1.91424 -4607 4 25.4691 41.6865 32.8295 -8.00507 -1.67316 12.192 -4608 6 5.19113 35.5773 31.6357 23.2413 -27.7984 27.0466 -4609 4 6.1476 35.7159 31.7435 -10.1506 4.22761 6.12862 -4610 4 4.96861 36.095 30.8978 -11.7512 22.2076 -38.0194 -4611 6 20.2191 22.0354 35.1304 9.30742 -6.19625 19.4235 -4612 4 19.9844 21.2003 34.7289 -5.16022 -6.81034 -3.33987 -4613 4 20.4782 21.7596 36.0473 -3.02096 9.85719 -25.9724 -4614 6 15.9251 36.5949 36.947 -9.13121 -30.7472 31.1466 -4615 4 16.4837 37.3712 37.0549 6.13876 -3.03661 -2.05614 -4616 4 16.031 36.0658 37.8159 -5.1453 16.1721 -39.9007 -4617 6 30.9484 22.4015 3.56131 11.993 -60.8988 -15.4947 -4618 4 31.1008 22.6958 4.44557 1.55935 5.74187 27.4751 -4619 4 31.2551 21.4217 3.58407 -13.4398 43.4536 -6.61432 -4620 6 47.0429 8.40936 14.2086 -4.42011 -15.6298 -34.0486 -4621 4 46.2603 8.29509 13.606 17.325 5.05196 18.7602 -4622 4 47.7698 7.89697 13.7682 -18.8904 11.0332 12.0247 -4623 6 34.1011 18.6159 3.148 0.361877 23.965 35.4915 -4624 4 34.6363 18.3397 3.89922 -0.845538 -0.743075 -4.07575 -4625 4 34.3812 18.1265 2.40098 2.04544 -17.9565 -29.3984 -4626 6 26.7996 25.3961 12.3408 -30.8906 -54.2954 26.5725 -4627 4 27.3117 26.1608 12.4557 20.536 44.4803 3.39785 -4628 4 26.6414 25.0259 13.2528 6.28377 9.49183 -30.6151 -4629 6 22.6108 25.7845 30.8845 17.3255 -0.303924 3.7754 -4630 4 23.4288 25.6954 31.4132 -11.344 -1.13015 -1.03332 -4631 4 22.2314 24.9052 30.7722 1.09512 -5.6623 7.4309 -4632 6 23.6311 9.76276 35.7585 -2.90797 -4.19552 -4.78319 -4633 4 22.8314 10.2832 35.6581 -5.74139 5.63622 4.02691 -4634 4 23.3139 8.86685 35.4998 11.2809 19.0625 6.63709 -4635 6 10.4076 36.7742 9.64242 -28.436 -9.9846 9.32351 -4636 4 9.50067 36.3875 9.59353 19.7531 11.7612 -0.53903 -4637 4 10.7226 36.8301 8.7426 3.69205 5.92187 -13.8772 -4638 6 4.00038 32.4265 25.8669 22.0714 10.4661 11.4497 -4639 4 4.38844 32.9375 25.1422 -1.34031 3.54398 1.69886 -4640 4 3.2706 31.9516 25.4996 -17.8371 -17.4963 -10.4987 -4641 6 29.085 26.0296 18.6527 19.273 -47.5776 11.2122 -4642 4 28.2115 26.0231 19.0264 -21.1607 3.13806 -0.423844 -4643 4 29.4632 25.1291 18.9323 -7.10954 42.4601 -14.5827 -4644 6 15.3089 1.3255 27.9792 -24.1234 20.5069 -17.5654 -4645 4 15.0496 0.974163 27.1169 2.04641 -4.01433 11.5068 -4646 4 14.7355 2.12388 28.0804 19.9995 -12.8223 4.08523 -4647 6 48.6106 2.88816 22.9655 -1.26722 3.55247 -0.201848 -4648 4 48.4165 2.02818 22.6182 -14.5439 -12.5884 3.03438 -4649 4 49.5001 2.98572 22.6432 10.4652 10.9023 -5.33271 -4650 6 53.0075 0.36099 19.7296 11.424 -8.43987 -8.95848 -4651 4 52.5965 41.9022 20.5162 -3.41206 4.78179 6.33318 -4652 4 52.3731 0.223553 19.0136 -6.83989 5.16364 0.289704 -4653 6 1.41074 17.5036 17.9462 -15.7932 -16.9445 -5.36496 -4654 4 1.29993 17.3585 17.0019 -2.92928 12.5396 -5.88676 -4655 4 1.38271 16.6004 18.2823 6.65411 -3.00458 14.0519 -4656 6 37.9084 19.0323 37.6056 -38.9323 8.68785 -13.5971 -4657 4 36.9858 18.7285 37.7384 11.3307 8.89304 -0.372118 -4658 4 38.4207 18.4342 38.1195 19.3518 -17.7067 16.118 -4659 6 26.9813 30.3571 38.0896 -0.527767 18.5171 -30.3811 -4660 4 26.1212 30.285 37.6565 1.23907 -9.17466 9.80696 -4661 4 27.2764 31.2069 37.701 2.1524 -13.2267 12.8694 -4662 6 20.0955 18.5722 3.03696 10.9017 21.9571 9.92937 -4663 4 20.0263 17.806 3.59422 -10.4522 -23.2015 2.62566 -4664 4 20.8322 19.0363 3.46766 -4.52129 0.073665 -16.3651 -4665 6 35.0841 6.94694 4.08385 8.40312 -14.6319 10.4582 -4666 4 35.6826 7.16069 3.3578 -1.64356 4.34706 -6.00978 -4667 4 34.2613 7.42764 3.99145 -7.61312 4.93718 -6.31016 -4668 6 22.2176 37.0878 31.2599 -35.8324 13.882 69.7054 -4669 4 22.1593 36.8558 30.3798 -4.04212 -13.8909 -61.3413 -4670 4 21.2552 37.1952 31.5589 44.4461 1.84169 -14.4682 -4671 6 12.3904 22.3711 41.8265 33.9103 21.3816 -17.5574 -4672 4 13.0623 23.0096 41.4404 -31.3175 -17.017 24.3472 -4673 4 11.7392 22.2302 41.1411 -5.71588 1.3909 -0.895108 -4674 6 43.2333 30.3145 23.1566 26.412 30.0652 1.94466 -4675 4 44.1443 29.9954 22.911 -23.9673 11.2944 4.28313 -4676 4 43.3588 31.2906 23.3811 -4.98348 -33.6726 -4.24118 -4677 6 16.5316 8.07904 16.6592 -13.1305 -2.58289 1.30551 -4678 4 16.426 8.46358 15.7881 -7.07274 -4.02537 -8.52635 -4679 4 17.4421 8.27811 16.8595 11.8389 2.77268 11.6749 -4680 6 10.0527 8.64979 31.7837 -8.97334 17.7557 -57.5223 -4681 4 10.1312 7.90747 32.3291 5.58005 -27.1767 37.8097 -4682 4 10.1183 9.47003 32.2578 1.92783 9.29621 23.4619 -4683 6 10.1389 6.52097 25.6279 25.2027 -9.57639 0.964906 -4684 4 9.42987 6.19895 26.1639 -19.2857 -8.54063 7.31181 -4685 4 9.7626 7.17299 25.0306 4.07146 -2.80849 4.96109 -4686 6 49.8614 7.23714 25.5252 -17.9172 7.62946 -5.56104 -4687 4 50.0467 6.31121 25.4422 2.69032 -18.6529 -6.42341 -4688 4 50.6907 7.63095 25.75 18.9978 12.6416 8.6826 -4689 6 18.4677 37.5766 33.9365 -27.5019 7.45217 1.11424 -4690 4 17.6855 38.1606 34.0956 24.1544 -3.52274 -4.16364 -4691 4 18.0518 36.7105 34.0373 4.53854 -5.63623 -1.47673 -4692 6 32.1991 34.7999 39.2511 37.7035 -28.7103 22.0041 -4693 4 32.3976 34.2973 40.087 0.14143 15.1618 -21.7552 -4694 4 31.3182 35.0784 39.3573 -42.2601 10.9481 4.26487 -4695 6 49.5371 23.9083 4.45427 26.1113 1.30104 -36.4507 -4696 4 49.7626 23.2251 5.06121 8.22711 -23.3511 16.8473 -4697 4 48.7895 24.3154 4.8182 -37.5883 23.1909 21.4935 -4698 6 6.05615 24.4755 33.9372 -3.62864 21.1406 1.2609 -4699 4 6.78781 23.8493 33.8811 -5.98028 -5.90455 -1.42734 -4700 4 5.44033 24.2071 34.6424 10.5748 -4.32926 -7.84557 -4701 6 1.71417 22.9797 24.1919 12.9465 25.751 -13.942 -4702 4 1.74027 23.9063 23.8744 -7.21984 -9.04225 7.93975 -4703 4 0.785802 22.7901 24.3299 -10.4675 -5.82386 8.34916 -4704 6 12.4544 16.5695 32.338 -33.1179 2.9171 31.5337 -4705 4 13.1434 15.995 32.5512 52.391 -27.2499 -12.3732 -4706 4 11.9701 16.4097 33.1768 -13.251 25.8897 -21.4653 -4707 6 21.3776 37.3784 27.9508 -6.73969 12.2577 23.3137 -4708 4 21.2203 37.3231 27.0262 1.16773 -1.52428 -34.5533 -4709 4 20.718 38.0458 28.2038 6.71566 -1.73666 8.03222 -4710 6 27.2299 40.8388 28.8031 2.48401 0.937021 1.60569 -4711 4 26.5367 41.5089 28.9565 6.65702 -12.2841 2.86921 -4712 4 27.4065 40.3185 29.6035 -12.9999 8.55112 -0.224288 -4713 6 0.993205 21.7261 13.5372 -53.3037 2.48171 -36.3839 -4714 4 1.86429 21.8093 13.8237 52.7771 -6.56786 29.3883 -4715 4 0.417346 21.4203 14.2472 8.63216 3.11646 10.526 -4716 6 22.3067 2.58146 8.73662 29.448 -13.2509 35.6107 -4717 4 22.9722 3.05705 8.24165 5.16658 9.50374 -8.2335 -4718 4 21.5154 2.5876 8.23764 -24.8297 4.23497 -21.3736 -4719 6 29.9953 17.8456 8.24313 -2.433 8.62767 -9.90081 -4720 4 29.054 17.6713 8.30654 -5.44558 -4.70631 2.21427 -4721 4 30.3746 17.4275 9.01982 5.69521 -3.15286 8.62416 -4722 6 3.62819 37.7118 25.7099 -17.1271 -24.8271 -10.3244 -4723 4 4.40422 37.1524 25.7956 9.9921 4.76654 4.66524 -4724 4 2.941 37.0477 25.4485 4.12723 25.8155 6.09629 -4725 6 26.809 27.648 36.3589 -37.7802 -17.2474 29.8166 -4726 4 26.8014 28.1831 35.5758 -1.13827 16.217 -13.4241 -4727 4 25.8725 27.5642 36.7259 28.3017 7.35189 -21.1707 -4728 6 13.3559 25.3099 38.116 1.93465 -14.8526 16.0582 -4729 4 13.2959 24.3789 38.4372 3.98877 20.6101 -4.99041 -4730 4 14.1146 25.694 38.605 -5.66874 -3.07699 -9.11419 -4731 6 49.7048 27.2599 6.72622 -1.43928 22.3256 -10.7839 -4732 4 49.6686 26.3369 6.45132 -5.99645 4.70457 -4.8273 -4733 4 49.2845 27.8697 6.04945 8.54794 -27.7312 19.0533 -4734 6 39.7449 11.5776 10.1987 6.84991 -8.95817 -1.04181 -4735 4 40.3059 10.8428 9.86803 -8.86198 19.4731 1.33094 -4736 4 39.0907 11.7833 9.50723 6.52335 -1.56097 1.75374 -4737 6 17.4857 24.9907 35.5559 -11.6728 -0.232318 -1.23817 -4738 4 17.2359 24.7743 34.6481 -9.71541 0.96097 3.2925 -4739 4 18.4326 24.9281 35.5495 18.729 -4.76527 0.24637 -4740 6 45.0886 34.9858 31.8393 -13.7853 -2.59791 -12.3576 -4741 4 44.2542 35.4282 32.0247 4.31579 11.0194 10.5125 -4742 4 44.8031 34.4855 31.0733 13.3341 -13.9746 -4.20839 -4743 6 30.2109 9.89077 31.3202 8.39813 20.0527 10.0978 -4744 4 30.4343 10.7522 30.9233 -1.69236 -11.2354 5.34707 -4745 4 30.0976 10.0887 32.2697 2.61193 -8.5831 -6.90929 -4746 6 32.3748 9.22464 6.61109 37.8815 -39.2378 -50.8405 -4747 4 32.2118 8.68084 5.76454 4.57858 20.451 35.1159 -4748 4 31.5433 9.4233 6.96427 -45.6188 15.529 19.6617 -4749 6 9.26845 24.9782 35.9229 1.19564 -9.02769 -15.4958 -4750 4 8.9564 25.4582 35.1216 5.49795 -4.99978 19.1154 -4751 4 9.87718 25.5584 36.4061 -8.42028 -2.10732 -11.5846 -4752 6 40.3335 1.48296 18.8902 20.9136 0.652934 -58.3414 -4753 4 39.6207 1.94237 19.2768 -32.228 11.5513 31.9135 -4754 4 40.836 0.952532 19.4949 5.43911 -12.9068 21.333 -4755 6 5.27733 10.6166 30.4293 -4.37857 29.6514 35.8012 -4756 4 5.00531 11.4476 30.0112 -0.880507 -1.63534 -8.13264 -4757 4 5.35863 10.9185 31.3957 -0.759826 -20.4729 -25.7258 -4758 6 25.6655 11.6994 25.6535 -15.8411 -39.3949 6.40341 -4759 4 25.8392 12.448 26.1908 9.94197 23.9877 11.5846 -4760 4 25.8146 10.9427 26.2759 4.01869 23.17 -23.7809 -4761 6 21.9208 20.0736 29.783 -0.661059 -23.1285 25.9828 -4762 4 22.5528 19.9674 30.5279 -9.0028 12.6586 -11.845 -4763 4 21.4796 19.2024 29.7633 3.30396 8.80601 -15.8778 -4764 6 10.0031 19.9894 34.5062 10.0701 -18.9504 -1.84201 -4765 4 9.43917 20.4787 35.093 -9.85162 7.82768 6.06887 -4766 4 9.97528 19.0642 34.823 3.96148 11.1077 -9.79004 -4767 6 24.6395 10.3611 12.2013 10.4056 19.7725 40.7349 -4768 4 24.7062 9.53294 12.699 -2.91134 1.50973 -12.3578 -4769 4 25.0089 11.0108 12.8733 -15.5791 -20.8054 -25.2752 -4770 6 50.4386 28.2959 11.551 52.3964 -11.4141 -41.8896 -4771 4 51.2944 28.7096 11.1811 -37.3824 -15.4271 20.8858 -4772 4 50.1484 28.8694 12.238 -9.02874 19.1251 18.783 -4773 6 13.9255 27.6321 25.0575 -30.7043 9.27758 -16.9407 -4774 4 13.4685 27.961 25.8505 6.53671 1.50814 -8.33226 -4775 4 13.405 28.0084 24.2853 19.6442 -13.6277 24.9436 -4776 6 46.1675 18.6723 40.4127 -24.7255 0.52235 -5.51451 -4777 4 45.2163 18.6287 40.1471 17.8616 -3.70574 0.193046 -4778 4 46.2526 19.5549 40.792 -2.63441 -2.56699 -8.45512 -4779 6 32.4875 14.1744 27.1342 -20.1773 -0.115465 -0.458595 -4780 4 31.894 13.6021 27.6676 10.0212 10.5514 -7.27374 -4781 4 32.1329 15.0809 27.2203 4.74838 -8.22403 2.71507 -4782 6 14.0641 36.351 13.3878 -9.69625 43.6715 -7.48797 -4783 4 14.0645 37.3444 13.3555 12.262 -25.9465 20.9036 -4784 4 13.2835 36.2347 12.8457 -5.28255 -22.0231 -7.64651 -4785 6 1.89477 36.5899 21.9857 -12.7075 -7.68583 0.53673 -4786 4 1.75133 36.5712 22.9388 2.01013 -3.06644 8.01032 -4787 4 2.81569 36.8315 21.8421 3.36212 -1.19737 0.805445 -4788 6 25.2943 31.8607 39.7417 -2.48011 0.614033 34.0265 -4789 4 24.999 32.7283 39.4716 -5.73903 6.77443 -6.35095 -4790 4 25.461 31.9431 40.7124 0.191009 -4.33082 -23.8473 -4791 6 6.4797 22.0186 1.29894 -12.0535 -14.7769 -6.17691 -4792 4 5.53353 21.8063 1.36197 11.0348 5.26157 5.70773 -4793 4 6.5732 22.8347 0.80957 1.58971 11.8894 0.78955 -4794 6 27.6266 25.0275 4.69979 7.76412 30.8855 29.066 -4795 4 28.5017 25.4862 4.66738 -16.9061 -15.4428 -5.02391 -4796 4 27.2115 25.3905 5.52919 8.95609 -10.8934 -21.2922 -4797 6 21.6474 30.9429 41.2213 -14.674 16.9935 -31.5335 -4798 4 21.3077 30.3434 41.8509 -10.7705 -24.5884 29.0962 -4799 4 20.9035 30.9616 40.5667 22.5963 5.39714 5.21952 -4800 6 32.3503 18.8691 12.7728 -7.52429 -0.383917 -18.241 -4801 4 31.3918 18.9773 12.8161 6.27066 1.36054 6.85895 -4802 4 32.4619 18.5656 11.8564 12.6246 0.663961 8.91714 -4803 6 35.6352 19.4593 21.1461 -10.1734 29.4522 17.7801 -4804 4 35.3511 18.62 21.5049 -2.07097 -11.6796 -4.30053 -4805 4 34.9906 20.1214 21.5255 16.9121 -20.2959 -15.2058 -4806 6 27.6974 17.9478 34.0105 3.72497 22.7808 11.4532 -4807 4 28.1244 18.3695 33.2449 -3.6365 -3.33971 3.70746 -4808 4 28.0134 18.5196 34.7467 -3.33496 -14.4526 -11.1074 -4809 6 34.1722 39.0415 14.8025 -0.588556 -5.09353 50.87 -4810 4 33.8492 38.3378 14.2426 -9.69809 -4.78927 -2.35124 -4811 4 33.6075 39.0103 15.6476 14.9636 10.6202 -38.8415 -4812 6 28.5063 3.47722 33.8826 -13.8698 -21.2799 4.06498 -4813 4 27.871 4.20321 33.9085 6.20243 8.28698 -1.91661 -4814 4 29.4175 3.76621 33.9059 10.9167 16.0273 -3.84391 -4815 6 34.9231 32.1486 6.55347 -48.5451 -22.9266 3.43697 -4816 4 33.9921 31.9748 6.9467 49.872 11.9331 -17.2337 -4817 4 35.5478 32.1135 7.28146 1.17984 3.66225 6.53991 -4818 6 31.8923 6.87344 23.517 2.73099 13.3553 4.48118 -4819 4 32.4005 6.72509 22.7097 -0.163961 -9.68163 3.8586 -4820 4 32.2042 7.75277 23.812 -2.19309 -5.80853 -1.60196 -4821 6 18.8495 1.74691 0.846251 -10.8424 6.73855 -33.2301 -4822 4 18.128 2.12906 0.287715 7.30697 -5.37966 19.0723 -4823 4 19.1812 2.42034 1.43504 -3.90896 9.02122 12.2654 -4824 6 27.0029 18.9235 11.8738 61.7268 20.0146 -35.0636 -4825 4 27.2277 19.7644 11.4142 7.64396 -16.2258 9.71345 -4826 4 26.1059 19.0334 11.9849 -72.3018 -1.47246 20.779 -4827 6 43.8315 11.1413 18.4425 12.0955 7.77381 31.2403 -4828 4 43.582 10.9955 17.5403 1.6883 -14.8273 -19.2234 -4829 4 44.4878 10.475 18.7348 -4.89818 7.49251 -15.5557 -4830 6 33.4942 40.5585 37.6724 7.87983 -3.11064 16.6213 -4831 4 33.9456 40.2455 38.4765 5.57637 6.44045 -9.71494 -4832 4 32.6057 40.2384 37.8499 -11.5443 1.61602 -9.31227 -4833 6 15.6218 26.7049 39.4143 -33.8245 -53.4627 11.7102 -4834 4 15.4245 26.9754 40.2985 -0.693124 5.44593 20.3253 -4835 4 16.1216 27.3809 39.0562 36.6223 43.7441 -31.7418 -4836 6 4.38199 13.876 40.8778 6.07973 -11.0772 -3.70535 -4837 4 5.33347 13.6897 41.0138 -14.6737 -0.272428 -1.39073 -4838 4 4.02273 13.2235 40.2449 7.64869 11.7946 8.98025 -4839 6 20.1779 10.396 38.2135 -21.4206 4.43784 1.78325 -4840 4 20.3564 10.9148 37.4134 10.9013 -11.3706 0.559506 -4841 4 20.991 10.2443 38.6984 6.99273 1.77474 -1.94206 -4842 6 15.1578 19.2491 23.8705 6.70925 0.197906 -4.49513 -4843 4 15.3523 20.1614 24.134 -1.79925 -4.44488 8.10361 -4844 4 15.0598 19.3463 22.9079 -1.20619 -5.61783 14.9214 -4845 6 47.881 28.6148 15.8048 16.8356 22.7469 11.8397 -4846 4 48.0602 27.74 15.4965 -2.52866 -23.0751 -5.40804 -4847 4 48.6281 28.8091 16.402 -10.5906 -5.01786 -6.93826 -4848 6 29.925 30.905 18.9707 11.7406 3.33263 -1.10353 -4849 4 29.0879 30.4807 18.764 -8.84985 -7.33813 -1.92291 -4850 4 29.807 31.8375 18.7873 -6.04184 4.11832 2.37084 -4851 6 11.9324 35.8064 28.512 -27.4265 24.0258 -21.7564 -4852 4 12.5706 36.1347 29.1334 15.2736 -4.81493 21.8335 -4853 4 12.2236 34.9831 28.145 8.79196 -20.6768 -0.490374 -4854 6 29.967 37.8624 25.4885 4.59009 -4.14727 -0.313094 -4855 4 30.2605 37.0012 25.8228 -4.78695 -0.224547 -14.1967 -4856 4 30.4431 38.4647 26.0537 0.190265 15.5785 7.27405 -4857 6 52.6385 28.1101 32.2696 27.4129 -14.0906 14.429 -4858 4 52.1837 28.8064 31.8018 1.35463 13.918 -3.63194 -4859 4 53.5572 28.4115 32.4361 -8.8806 -0.527566 -10.0859 -4860 6 37.0194 40.0856 11.9811 12.8522 -14.0915 -8.99985 -4861 4 36.2698 40.6335 12.1547 -20.3135 9.86443 5.11387 -4862 4 37.3206 39.8255 12.8594 7.06858 1.59634 4.17732 -4863 6 16.6823 16.7862 36.5016 -40.0159 24.4695 -22.7659 -4864 4 15.9639 17.4464 36.7433 30.1481 -22.6997 -3.51596 -4865 4 16.709 16.8774 35.5181 2.88256 -1.64708 20.873 -4866 6 28.0056 4.17661 38.8341 -15.1907 4.44859 15.1459 -4867 4 28.8664 4.34511 39.2253 10.7528 -1.70638 -4.98709 -4868 4 28.1362 3.72531 37.9969 -2.54795 -6.06729 -7.91519 -4869 6 28.9121 0.2613 17.7196 11.2429 43.6022 -6.13696 -4870 4 28.206 0.913023 17.5432 1.57334 -10.0134 0.986336 -4871 4 28.5175 41.3357 17.883 -22.7122 -29.353 3.51833 -4872 6 22.9275 20.1119 26.272 10.3141 -17.1908 1.54721 -4873 4 23.597 20.0083 26.9758 -6.33812 5.26805 -6.32666 -4874 4 22.343 20.8217 26.5441 4.5912 8.26641 6.04785 -4875 6 49.4104 29.8887 13.4211 -27.0365 40.5227 7.20695 -4876 4 49.0994 30.824 13.2506 14.963 -27.7355 -0.582388 -4877 4 48.6865 29.5209 13.9525 8.18699 -4.12202 2.86767 -4878 6 2.45827 24.8307 7.29137 -22.8365 1.45709 37.207 -4879 4 2.32025 24.5445 8.23446 11.0976 11.5137 -22.649 -4880 4 1.77037 25.516 7.1857 7.09177 -11.7652 -6.70138 -4881 6 30.3948 26.4611 14.3404 -21.8067 20.3233 2.80707 -4882 4 31.1122 26.3224 14.9982 -12.4575 10.0222 -1.69757 -4883 4 29.8137 27.2743 14.5309 34.7851 -33.9666 2.2264 -4884 6 27.0321 32.5068 3.14827 -14.3662 17.1598 1.60641 -4885 4 26.4039 33.1156 3.62616 22.1531 -16.0826 -13.2832 -4886 4 27.3831 31.9163 3.82559 -1.71579 -4.01879 3.19031 -4887 6 34.2634 14.7959 1.27313 2.99828 -7.05923 -10.0889 -4888 4 35.1835 14.4352 1.19997 -20.4533 4.23129 -4.55267 -4889 4 33.713 14.3258 0.588346 24.9828 8.52884 21.9593 -4890 6 30.022 8.54163 1.32868 -10.2939 -13.069 16.6852 -4891 4 30.0052 9.45247 1.0409 -5.08902 11.4157 2.73646 -4892 4 29.2496 8.43498 1.92915 15.9692 5.13326 -10.6744 -4893 6 42.5647 11.5185 27.7103 -4.68909 6.08661 -3.61857 -4894 4 42.216 12.3928 27.8946 9.09127 8.642 -2.18095 -4895 4 41.8714 10.9656 28.0604 -6.00702 -16.6262 4.78299 -4896 6 52.461 39.5492 17.8365 12.2605 -26.0754 -32.0817 -4897 4 51.7553 39.7908 18.3861 -39.7898 9.50592 28.6027 -4898 4 53.1226 40.1801 18.0155 30.5873 23.5517 5.0779 -4899 6 33.2136 4.91918 31.6183 -6.56942 36.6821 16.923 -4900 4 32.9061 5.86322 31.5606 3.78329 -26.1329 5.01225 -4901 4 32.8884 4.48208 30.835 -2.61462 -3.20134 -11.4125 -4902 6 6.2936 16 18.7476 -12.5252 7.31014 22.9936 -4903 4 5.79227 16.5246 19.4216 24.8679 -4.64947 -16.2991 -4904 4 5.64136 15.3462 18.514 -6.08951 -9.62478 -9.34051 -4905 6 8.52033 14.5365 24.6875 -9.84601 3.26611 -2.01077 -4906 4 9.36791 14.3624 25.0978 6.86066 0.30113 1.47813 -4907 4 8.18366 13.6846 24.3866 1.77672 -1.96336 3.84573 -4908 6 22.6911 10.1297 32.1351 -27.5214 -52.5729 10.3709 -4909 4 22.3884 10.9899 32.3649 2.47289 32.4289 -2.22619 -4910 4 23.5203 10.1223 31.6812 20.4751 21.0076 -14.9216 -4911 6 11.292 2.12704 14.679 -26.9964 -14.1635 0.457424 -4912 4 10.3004 2.01295 14.5746 25.662 7.6895 -7.09692 -4913 4 11.7079 2.38272 13.8392 -0.157448 -3.91762 -7.39795 -4914 6 44.9096 15.591 36.2717 33.6405 -1.91298 -30.8875 -4915 4 45.0764 15.4828 35.303 -3.33411 7.1012 27.4883 -4916 4 43.99 15.446 36.3379 -31.2371 -2.78707 10.2167 -4917 6 9.72465 19.0179 31.2227 19.6005 -24.8416 -16.8371 -4918 4 10.5897 19.4265 31.3159 1.30764 -1.40065 3.11778 -4919 4 9.11252 19.5759 31.653 -23.8989 17.913 16.8503 -4920 6 51.9714 7.58847 16.6881 21.0297 -20.8952 -55.8985 -4921 4 52.6598 6.90966 16.567 -10.1825 8.15334 22.1112 -4922 4 51.6538 7.5728 15.7392 -8.87714 21.5211 34.751 -4923 6 31.4317 34.7753 36.422 -0.942044 -9.40807 -31.2122 -4924 4 31.7249 34.7672 37.3268 6.30465 10.9632 14.3566 -4925 4 31.2441 35.6593 36.0754 6.17504 10.5044 11.3925 -4926 6 4.22663 15.0937 15.3657 -12.9272 -11.1361 22.285 -4927 4 4.10058 14.8824 16.3208 1.18356 5.05287 -17.269 -4928 4 5.17453 15.1773 15.2713 12.4851 5.61025 -4.39011 -4929 6 47.7531 20.6767 28.0224 11.2198 -3.02063 -12.9376 -4930 4 47.6925 19.771 27.6598 -2.10862 13.919 9.51432 -4931 4 48.3916 21.1163 27.4231 -12.1395 -0.81062 10.3277 -4932 6 15.815 1.15165 24.4078 -58.142 17.9603 -16.0616 -4933 4 15.2825 0.557615 24.9446 12.6892 -15.3828 1.22604 -4934 4 15.0545 1.63036 23.9524 41.7436 -8.72437 9.7488 -4935 6 34.5811 39.7067 40.0776 25.1973 35.6425 -42.1699 -4936 4 34.2041 40.3093 40.7031 -18.6223 -6.05265 24.4589 -4937 4 34.3171 38.8242 40.1905 -21.7766 -38.3424 16.3885 -4938 6 20.1959 32.1778 34.4064 -21.1308 28.8301 22.4919 -4939 4 19.7756 32.8897 35.0113 13.9702 -37.934 -23.8567 -4940 4 21.1121 32.1056 34.6926 -2.59197 2.17732 9.39736 -4941 6 19.2966 38.5284 11.8437 26.0429 16.0259 -0.414132 -4942 4 19.2747 37.5954 11.9891 -3.91225 -17.7096 3.53088 -4943 4 20.0654 38.8356 12.3915 -17.5462 -2.40166 -9.14392 -4944 6 6.53181 13.5016 26.8314 -26.032 48.4544 -13.2533 -4945 4 5.96734 14.0602 26.204 31.1233 -23.713 24.7575 -4946 4 6.50803 12.6321 26.4707 -0.853216 -24.803 -10.5103 -4947 6 23.5899 31.5666 33.3383 5.98922 -6.50638 -9.93577 -4948 4 23.0479 31.6137 34.1308 1.15429 -4.79335 1.92272 -4949 4 23.6428 30.629 33.0606 -7.31668 7.17491 0.194963 -4950 6 41.0566 31.9249 16.2102 56.5158 -30.8904 -22.4873 -4951 4 41.9283 32.0344 16.659 -25.525 5.07155 -0.752829 -4952 4 41.3339 31.2779 15.4895 -19.0587 21.5349 12.1439 -4953 6 31.7523 18.8667 19.3593 3.35741 25.414 0.712525 -4954 4 32.0759 19.7269 19.7383 -8.81617 -22.0304 -12.3923 -4955 4 31.2718 18.4298 20.0739 7.05067 -2.94537 3.38628 -4956 6 10.4941 4.11052 19.3414 6.42456 29.4713 -33.6332 -4957 4 9.72315 4.57262 18.9428 7.32966 -14.5804 7.11 -4958 4 11.2095 4.33965 18.6811 -15.5987 -11.1936 33.5314 -4959 6 1.36933 32.4682 19.2841 21.0988 -14.4161 24.2075 -4960 4 2.01529 31.7231 19.2122 -13.2253 9.85044 -10.2965 -4961 4 1.01532 32.721 18.4367 5.36339 -4.1954 -20.4987 -4962 6 42.8687 16.8583 24.9978 45.6636 -43.4462 -50.5941 -4963 4 42.5079 17.7172 24.9824 -17.3855 32.283 0.331695 -4964 4 43.4322 16.7911 24.1362 -30.0172 8.55702 44.8961 -4965 6 45.317 19.181 4.10785 3.8422 34.8536 -4.15721 -4966 4 46.019 19.8398 3.89275 -2.03222 -14.2005 10.5278 -4967 4 44.6424 19.7199 4.5744 3.59127 -10.0852 -3.22755 -4968 6 29.1417 19.8939 35.7514 6.11075 -32.58 -16.2332 -4969 4 28.6926 20.3067 36.4515 -23.9686 13.1333 31.3988 -4970 4 29.2427 20.5957 35.1143 7.28783 5.32225 -12.4577 -4971 6 31.9564 21.8498 19.6592 2.82401 14.2352 -0.350828 -4972 4 32.7548 21.9543 19.0677 -31.5105 -7.28354 24.2009 -4973 4 31.6217 22.7614 19.848 10.5207 -20.3739 -6.13763 -4974 6 39.1981 8.2717 18.8284 -32.9061 14.1933 0.428726 -4975 4 38.9624 7.35629 18.6463 1.07118 -6.83808 -1.96228 -4976 4 38.3348 8.76709 18.6863 31.0345 -14.9445 1.78619 -4977 6 33.2818 13.2775 41.2684 -13.2208 -33.3764 1.31987 -4978 4 32.393 13.5626 41.0006 -3.83673 2.91025 7.56978 -4979 4 33.1808 12.3338 41.5845 5.22215 22.8712 -2.04361 -4980 6 5.9413 29.5498 35.797 -32.456 -34.3071 -6.72563 -4981 4 6.35963 30.284 36.1739 22.861 33.0715 10.0739 -4982 4 6.49565 29.1835 35.1072 8.32337 2.91553 -5.44074 -4983 6 13.0321 34.2086 31.915 -24.835 -40.2345 36.8573 -4984 4 13.0272 33.4084 31.376 1.88868 -0.760633 -7.07942 -4985 4 12.5489 33.9041 32.737 18.271 18.5714 -18.1292 -4986 6 33.9591 21.7903 18.011 18.8454 -21.734 -8.71067 -4987 4 34.7458 21.1933 18.012 -16.5142 3.18134 2.17277 -4988 4 34.2934 22.6573 17.8484 16.983 20.6817 -10.003 -4989 6 35.9748 41.3385 18.1559 -11.3515 0.0380054 -35.3696 -4990 4 35.8093 41.5204 17.1769 9.12346 -12.4659 34.6458 -4991 4 36.6045 0.098617 18.3947 7.40652 10.177 5.52403 -4992 6 34.8515 37.6574 30.5934 11.7527 -35.7483 27.3047 -4993 4 35.1492 36.8608 30.1169 2.57906 15.2804 -10.7791 -4994 4 34.9371 37.33 31.5271 -8.43612 19.6249 -16.9201 -4995 6 26.002 34.4146 4.67279 -8.48904 3.78898 9.19231 -4996 4 25.4415 34.5852 5.42871 -16.9308 -4.98482 2.97274 -4997 4 26.7915 34.86 4.9592 18.7282 4.65341 -5.76761 -4998 6 19.0552 33.5605 1.32358 6.49267 31.5074 -37.6332 -4999 4 19.8139 33.1288 1.70335 8.38847 -12.1483 9.88993 -5000 4 19.4402 34.1326 0.589952 -11.7405 -21.1797 25.0755 -5001 6 25.2648 8.23393 8.59155 9.31521 -3.65292 19.8467 -5002 4 25.4875 8.13778 9.5404 -3.07709 1.08931 -10.3145 -5003 4 25.4314 9.16241 8.38927 -1.28134 -0.00667841 -6.07783 -5004 6 12.8479 19.6935 13.0483 24.3757 5.37981 -4.8091 -5005 4 11.9603 19.9957 12.9501 -28.6845 1.86907 1.18076 -5006 4 13.3523 20.516 12.8959 -4.89806 -16.374 -0.906345 -5007 6 53.3502 11.4299 5.80806 17.1624 -7.42289 17.7098 -5008 4 53.8461 12.0471 6.36061 9.49207 -4.93163 0.0376 -5009 4 52.6392 11.9481 5.49246 -25.6427 10.4986 -14.7278 -5010 6 9.84876 16.0411 31.2026 18.9205 20.8399 7.27663 -5011 4 9.06508 15.7062 30.7868 -18.8641 -2.54228 -13.3824 -5012 4 9.84527 17.0253 31.1624 -7.05614 -14.0763 0.861631 -5013 6 25.427 20.2931 3.30062 11.4464 23.222 26.9187 -5014 4 25.5454 20.7694 4.15249 -9.33169 -17.4988 -10.5652 -5015 4 25.6323 21.0333 2.7154 -3.32412 -15.1122 -12.6987 -5016 6 20.7611 8.20749 15.6389 12.285 -44.7943 -30.6071 -5017 4 20.4521 8.55687 16.4556 -20.4937 3.03897 24.5457 -5018 4 20.4185 7.27697 15.5079 3.31214 29.403 13.2982 -5019 6 37.6491 8.60321 9.97383 13.4411 2.14626 39.4708 -5020 4 37.9762 7.71523 10.2023 -7.3296 7.95364 -3.74733 -5021 4 37.281 8.55077 9.10696 -2.37522 -5.79058 -16.8845 -5022 6 50.6587 4.51935 24.2622 -13.5896 -19.0591 8.29097 -5023 4 49.9232 3.87067 24.2726 8.09814 12.5004 -4.89174 -5024 4 51.4381 3.99879 24.4754 4.23299 2.4676 7.18675 -5025 6 20.1738 24.8175 34.9087 -20.6162 39.8894 -22.5586 -5026 4 19.8889 25.4664 34.1955 11.6566 -19.5752 19.2833 -5027 4 20.4138 24.0094 34.4666 -0.241841 -16.354 -5.00311 -5028 6 30.5812 22.5243 11.2258 -36.8716 21.596 38.6978 -5029 4 31.1688 21.9929 10.7494 35.9784 -15.9007 -22.5785 -5030 4 31.0799 23.2498 11.6175 0.71333 3.79074 -7.65826 -5031 6 17.3246 40.781 8.03002 -31.7256 21.6985 11.3561 -5032 4 17.3609 40.073 8.69249 8.70624 -3.14378 -12.3263 -5033 4 18.1517 40.9293 7.58873 21.0517 -16.9909 -7.06703 -5034 6 23.9551 41.0422 26.0635 49.9815 4.82526 35.6353 -5035 4 24.3667 40.5978 25.3173 -4.54613 -3.84774 -13.2149 -5036 4 23.0402 41.1884 25.9461 -38.539 -4.36769 -14.447 -5037 6 9.79432 25.5848 27.2203 6.65484 -20.1236 -27.319 -5038 4 10.0774 24.9678 26.4912 -4.54744 21.2611 22.5851 -5039 4 10.2742 25.3181 28.0139 -2.97183 -5.43805 2.20583 -5040 6 35.2559 29.8148 24.7567 4.66903 26.9266 -5.93859 -5041 4 34.3843 29.755 24.359 -8.51564 -12.4096 -2.57191 -5042 4 35.4992 30.7322 24.5163 3.09853 -9.53322 8.65044 -5043 6 2.14554 4.24448 10.5593 -22.2482 14.7122 10.1934 -5044 4 1.71214 4.34677 11.4486 21.0071 -10.277 -13.7719 -5045 4 1.55235 4.73342 9.96914 3.10164 -3.012 2.95666 -5046 6 43.1737 3.93442 23.504 -19.8173 -22.9925 0.828755 -5047 4 43.8868 4.03822 22.8829 13.7397 8.75634 -8.56433 -5048 4 42.5624 3.30318 23.0634 7.12322 11.7882 3.68849 -5049 6 18.8936 22.6308 2.43475 37.4693 -11.6119 5.39147 -5050 4 19.8359 22.2985 2.41568 -31.8063 3.38645 -2.45846 -5051 4 18.7431 22.7947 3.37318 -4.67781 1.83629 -1.28906 -5052 6 20.5039 18.9394 41.5502 -45.0653 -1.00263 50.2155 -5053 4 20.0478 18.6838 0.506021 30.3651 -1.16827 -32.2456 -5054 4 19.9073 19.6506 41.2865 12.7012 -1.26976 -15.3796 -5055 6 26.407 7.54687 29.1121 1.4357 2.47637 1.41449 -5056 4 25.6724 7.10479 28.6297 19.9382 8.96422 9.98625 -5057 4 27.0918 7.77745 28.4582 -11.2115 -7.41118 6.83701 -5058 6 25.6474 35.5684 33.7551 28.3954 -27.4775 -24.9773 -5059 4 26.3573 36.1942 33.5448 -9.56627 7.56335 10.8035 -5060 4 25.9974 34.7724 33.2466 -29.6941 19.0168 23.1671 -5061 6 24.829 0.49304 8.41898 49.9168 25.8876 59 -5062 4 25.5758 0.370102 9.1289 -47.1903 5.46774 -40.7742 -5063 4 24.7798 41.5674 8.0141 -4.73142 -31.3088 -22.2887 -5064 6 17.0191 17.3177 3.44507 -46.3903 19.7373 51.2207 -5065 4 16.2469 17.9517 3.64762 33.8447 -23.651 -21.8207 -5066 4 17.1185 16.9245 4.35427 5.98982 5.76213 -27.3591 -5067 6 40.1787 32.0965 19.3495 -2.04197 44.459 1.39821 -5068 4 39.7315 31.3261 19.6693 2.08081 -28.8107 0.337304 -5069 4 40.9568 31.869 18.8472 6.84111 -19.9226 -1.15348 -5070 6 23.382 26.6945 6.30636 26.5913 52.1271 15.5788 -5071 4 24.0556 27.4456 6.44648 -17.1373 -33.2326 -1.34025 -5072 4 22.7142 27.1153 5.75328 -6.08389 -4.52619 -7.61988 -5073 6 28.6524 28.5085 1.41248 40.8971 -13.4399 -11.1281 -5074 4 28.8916 29.4207 1.30452 -22.1266 20.7664 -4.28256 -5075 4 29.5558 28.1704 1.18501 -32.1523 -8.03877 13.3744 -5076 6 12.0456 6.33448 14.0345 -15.8903 -34.4 -29.7535 -5077 4 11.2902 6.05291 13.4483 16.0844 18.9407 21.6686 -5078 4 12.7823 5.99392 13.4906 5.33453 16.7776 14.1371 -5079 6 20.1258 33.7078 32.0959 -18.1893 1.56867 -4.93457 -5080 4 20.1945 33.0222 32.7471 -6.29187 -8.74149 18.477 -5081 4 21.0272 33.8529 31.8657 20.6776 7.89431 -10.0095 -5082 6 12.0665 33.3691 34.5458 -17.2285 -56.0193 -22.1145 -5083 4 11.5086 33.8793 35.1106 -7.76206 16.4549 16.9315 -5084 4 11.5605 32.4987 34.4127 27.4292 33.0374 0.608769 -5085 6 6.00658 22.2666 25.0532 -19.3255 -5.39958 94.237 -5086 4 5.834 22.4197 24.1868 -9.01045 11.6196 -89.8037 -5087 4 5.17345 22.6031 25.4913 31.6285 -9.76338 -3.83253 -5088 6 28.8848 9.49767 11.035 16.7623 9.63116 22.4077 -5089 4 29.0495 10.2086 11.6768 10.1151 -22.3542 -11.392 -5090 4 28.083 9.83925 10.6889 -25.6685 -5.48517 -25.0151 -5091 6 25.9808 31.1499 24.8669 6.22835 -24.9986 7.12483 -5092 4 26.2942 31.9621 24.5011 4.31737 18.7644 -10.9339 -5093 4 26.6597 30.4768 24.6157 -18.0541 8.02771 8.13926 -5094 6 17.4051 22.6403 26.9653 -7.75883 36.9734 2.0054 -5095 4 17.2144 23.5004 27.4753 3.96627 -41.4428 -18.3441 -5096 4 17.5261 21.9375 27.6083 1.93016 -8.19761 6.25563 -5097 6 30.9714 17.6252 1.64088 21.0154 14.9482 37.3685 -5098 4 30.2059 17.6112 1.0839 -20.4324 5.80492 -14.3468 -5099 4 30.9516 18.4373 2.23396 3.22156 -25.7853 -22.8165 -5100 6 35.2764 9.72503 11.2414 -18.3895 -2.76749 -51.624 -5101 4 34.6551 9.56245 10.4589 20.7383 2.80865 37.1903 -5102 4 36.1302 9.43155 10.8742 2.68762 -2.05229 10.7544 -5103 6 12.0172 10.802 4.27563 -38.9121 -6.07101 -4.90761 -5104 4 11.4313 10.6374 5.04504 13.8247 1.49432 -7.40831 -5105 4 11.4074 10.5604 3.53263 22.811 5.33779 9.30002 -5106 6 52.9577 23.1313 7.67787 -9.3269 3.09364 -7.79077 -5107 4 53.8153 23.0871 7.22609 1.51949 2.98805 -1.25247 -5108 4 52.6879 24.0607 7.78743 10.5919 -6.87524 0.0783357 -5109 6 27.3762 5.80009 23.1013 37.771 37.8703 25.2466 -5110 4 28.2178 5.56094 23.5856 -32.2451 -1.57897 -13.9899 -5111 4 27.4704 6.79781 23.0764 -15.1432 -38.3322 -6.34326 -5112 6 22.7771 37.7063 15.5287 -6.89324 -10.2053 44.7861 -5113 4 22.8198 37.7465 14.5962 3.81902 5.91484 -35.4551 -5114 4 23.2903 36.9427 15.8415 -1.83068 2.7653 -4.67104 -5115 6 30.583 30.1381 39.7472 11.9278 5.78959 4.89923 -5116 4 30.1399 29.6129 39.0656 -4.27402 4.25284 -2.63349 -5117 4 30.6547 31.067 39.4612 -8.3831 -13.7724 -7.9353 -5118 6 26.5154 14.8633 29.9609 11.0831 -12.5589 -33.9006 -5119 4 25.6935 15.2477 30.2118 -18.1143 15.4408 19.147 -5120 4 27.1376 14.9035 30.6723 6.99544 5.71887 23.1856 -5121 6 9.52617 19.5446 37.4141 -27.8096 33.0225 -3.94279 -5122 4 8.56344 19.6819 37.5998 22.5694 -19.9005 4.13551 -5123 4 9.71087 20.3892 36.9619 8.68778 -16.8671 10.038 -5124 6 0.93064 14.8656 2.69338 -45.7679 -11.5139 71.6593 -5125 4 1.44105 15.217 2.01526 37.3122 25.2366 -40.5783 -5126 4 0.982855 15.4275 3.5214 11.2099 -15.0526 -29.9277 -5127 6 46.4291 27.1302 41.5927 44.8021 -5.11347 -18.4756 -5128 4 47.4269 27.1857 41.3316 -52.8753 -1.56841 10.8767 -5129 4 46.0453 26.5632 40.9031 3.09365 7.20255 7.14326 -5130 6 47.6703 23.0461 21.3817 14.1329 62.5249 18.4178 -5131 4 46.9615 23.2467 20.7836 -14.1781 -2.67912 -10.5965 -5132 4 47.8255 22.1376 21.4096 0.736735 -54.6337 -3.62162 -5133 6 39.861 22.2186 3.09273 14.3751 -13.6386 -17.8056 -5134 4 38.9812 22.2192 3.47284 -7.54245 -0.786418 6.90323 -5135 4 40.0217 21.2868 2.78929 -10.5756 29.8648 14.1337 -5136 6 14.9857 14.9315 33.4628 8.45923 30.4043 17.83 -5137 4 15.3946 15.8263 33.6275 -11.7248 -28.7506 -9.93609 -5138 4 14.5839 14.7058 34.318 1.67348 -1.86342 -8.89677 -5139 6 27.3225 11.4951 31.9326 -53.5602 -46.3542 13.457 -5140 4 26.8632 12.0627 32.5566 10.8872 8.4751 3.08438 -5141 4 28.1269 11.8297 31.6518 53.6341 36.944 -15.9306 -5142 6 36.7606 7.97817 7.63938 -5.6216 -14.483 -15.6739 -5143 4 35.961 7.43887 7.80711 8.78578 3.79539 -7.6162 -5144 4 37.414 7.37034 7.2323 -6.45073 3.96969 3.37374 -5145 6 49.4351 9.64395 18.2091 29.626 55.2849 10.866 -5146 4 50.1121 10.1978 17.7651 -9.80365 -29.4086 -13.348 -5147 4 49.2806 10.2909 18.9191 -22.4891 -21.6225 2.73598 -5148 6 27.0558 33.8708 10.7695 -35.2964 21.4972 9.63291 -5149 4 27.0077 33.3399 10.0051 13.5655 -23.8621 -34.587 -5150 4 26.1863 34.3133 10.6733 10.9844 1.63438 18.9088 -5151 6 11.1931 37.467 6.82672 4.88099 -16.6436 19.1561 -5152 4 10.8369 38.341 6.72067 -6.30082 13.8936 -5.38019 -5153 4 12.1372 37.6177 6.93955 5.33816 -5.06614 -4.03667 -5154 6 19.2682 19.4041 21.904 -23.2853 8.1035 46.9014 -5155 4 18.5523 19.4276 21.2977 -21.2798 -5.04156 -20.5384 -5156 4 20.0545 19.4439 21.4012 35.6905 -5.22778 -21.4405 -5157 6 54.5004 2.91828 22.5705 32.5661 -1.01917 48.733 -5158 4 54.2618 3.02388 21.6728 -2.16971 10.501 -40.9175 -5159 4 0.435524 3.25313 22.7695 -30.9494 -6.38648 -13.13 -5160 6 45.0599 10.868 24.2364 14.5135 -18.2796 4.13426 -5161 4 44.3635 11.4663 23.9664 0.226806 13.7258 12.1538 -5162 4 45.5813 11.1999 25.0017 -10.9868 0.331296 -15.4884 -5163 6 14.3917 34.4176 24.7766 -9.76404 -18.453 -6.38428 -5164 4 14.7761 35.2693 24.9957 4.99605 2.44674 1.2141 -5165 4 14.8449 34.0832 23.9904 0.575187 7.45256 -7.27956 -5166 6 50.5869 17.5623 4.30497 19.1488 -58.6727 24.3661 -5167 4 51.3501 17.8958 4.78847 0.670503 12.5806 -1.04554 -5168 4 50.1422 18.2474 3.88142 -19.7161 48.0777 -23.3625 -5169 6 14.9242 33.337 34.1076 -18.6172 33.5363 80.554 -5170 4 15.0808 32.9083 33.3321 11.226 -38.5345 -73.3592 -5171 4 14.0723 33.0217 34.4665 7.96171 10.4343 -9.42002 -5172 6 20.8631 33.5747 38.9135 21.2953 11.2024 -25.7312 -5173 4 20.865 34.0752 39.7143 -3.94121 7.45437 24.6588 -5174 4 20.36 32.7884 39.0656 -12.436 -21.6406 1.81461 -5175 6 7.7707 4.74963 26.7362 26.5342 -10.6541 19.1955 -5176 4 7.23261 4.91898 27.5026 -6.83786 10.9421 8.37469 -5177 4 7.15089 4.73593 26.0203 -3.95236 1.60233 -15.9617 -5178 6 9.2875 21.4887 22.2941 45.0197 -19.5209 20.7118 -5179 4 8.6739 21.9912 21.7696 -4.21454 15.1903 -23.2464 -5180 4 10.2572 21.6206 22.0058 -46.5259 5.6334 -2.177 -5181 6 20.5439 38.2154 8.85856 -11.8412 3.64647 49.7312 -5182 4 20.3505 38.5634 9.79035 9.75602 -4.66312 -40.2998 -5183 4 20.2844 37.2891 8.95048 10.2824 2.6457 -7.05014 -5184 6 30.1005 39.0839 30.7484 -12.1958 38.1552 23.9792 -5185 4 30.3724 39.9578 31.2326 -12.541 -45.9124 -25.2432 -5186 4 29.1103 39.003 30.8437 30.6219 6.07536 -1.13857 -5187 6 16.0462 22.036 24.5064 2.37861 -9.55962 -5.99251 -5188 4 16.6334 21.9741 23.7207 6.17482 7.89117 19.2285 -5189 4 16.5569 22.3155 25.2979 1.4399 -2.17025 -8.02685 -5190 6 5.74172 29.2061 14.4603 -14.7312 11.1013 -1.58992 -5191 4 6.41865 28.6839 14.8489 24.8954 -16.4528 0.429681 -5192 4 5.37542 29.618 15.2515 -13.4536 5.99623 -6.25212 -5193 6 28.0689 3.08071 25.2267 -3.20814 35.3244 14.901 -5194 4 28.6407 3.76435 24.8336 -2.36389 -14.401 -4.10269 -5195 4 27.6795 3.6106 25.9691 7.41152 -23.0621 -10.2478 -5196 6 45.9381 29.3111 31.4283 -35.5447 25.9568 9.82539 -5197 4 45.677 28.707 30.7493 2.31008 -18.1922 -21.3643 -5198 4 45.1265 29.9079 31.4744 34.4717 -15.8255 11.1052 -5199 6 11.2229 22.8376 36.7897 -1.27591 2.9175 -5.69903 -5200 4 10.6623 23.4314 36.25 10.4728 -5.78036 -0.0474996 -5201 4 12.0147 22.5841 36.2713 -9.37786 4.28983 5.66853 -5202 6 18.9444 40.1485 39.92 -15.471 -8.01044 2.33142 -5203 4 19.1439 39.1941 39.9507 -1.34087 5.25319 4.4419 -5204 4 18.8847 40.4877 40.8271 3.43659 -8.21326 1.76593 -5205 6 23.5503 26.0803 21.2869 1.98517 -8.46863 16.2364 -5206 4 22.847 26.649 20.9475 -0.393515 -5.32061 4.06564 -5207 4 23.2913 25.6403 22.1336 -2.29953 13.2014 -21.5927 -5208 6 16.8518 5.38834 15.8565 -25.8193 5.07215 -6.0744 -5209 4 16.3979 5.3834 15.0179 8.08064 -16.6857 -11.3384 -5210 4 16.3642 6.13153 16.2159 17.5374 8.90145 23.838 -5211 6 12.0293 26.6115 15.0052 48.8575 28.3431 -20.5386 -5212 4 11.753 25.9113 15.557 -22.1508 -25.2102 16.954 -5213 4 11.3677 26.9943 14.4309 -20.7091 -9.23994 -0.184726 -5214 6 14.3404 41.4231 2.37222 21.8802 31.2536 -15.2067 -5215 4 13.6639 41.0433 2.88545 -29.1815 -25.4177 23.2655 -5216 4 14.3137 0.446574 2.65591 6.04323 -12.5169 -2.89291 -5217 6 50.3994 35.8721 9.32148 7.74023 -5.00078 -0.0244409 -5218 4 50.7985 35.7097 8.44539 1.7624 12.9821 5.72804 -5219 4 50.9327 36.5364 9.8137 -9.76519 -8.88391 -14.7497 -5220 6 11.3732 22.6657 26.8674 13.5542 4.36995 9.37334 -5221 4 12.2226 22.4007 26.49 -3.86507 -2.48494 3.34128 -5222 4 10.7274 22.4174 26.2153 -14.8849 -5.84603 -9.40936 -5223 6 8.44501 34.5567 21.2657 -4.1178 -59.9386 7.63204 -5224 4 8.06567 35.1301 21.9247 -8.42944 2.78434 16.8569 -5225 4 8.10966 33.58 21.4462 13.1168 58.8803 -11.2866 -5226 6 9.4289 8.66253 24.4817 -31.3326 14.2813 -20.5935 -5227 4 8.45611 8.64572 24.2655 24.8039 10.7682 6.42659 -5228 4 9.52915 9.21836 25.2644 -0.461641 7.68001 5.20174 -5229 6 32.603 22.3274 34.5057 1.1064 -2.38466 -37.2003 -5230 4 32.4525 23.1707 34.0368 4.85154 -2.46017 7.68642 -5231 4 32.8396 22.5701 35.3818 7.58742 14.9461 32.9529 -5232 6 26.736 26.1837 7.12165 10.4716 16.8024 -17.1295 -5233 4 25.9537 25.8031 7.51207 -7.84415 -15.2109 12.7352 -5234 4 26.4604 27.1054 6.93432 8.77765 -19.2484 4.4957 -5235 6 34.0014 11.9295 3.96807 -3.56186 4.82634 5.33773 -5236 4 33.6494 11.5631 4.78494 7.3544 2.33703 4.85457 -5237 4 33.8594 12.8842 4.06904 0.478869 -2.08104 -5.13073 -5238 6 21.473 20.924 37.1992 5.8677 19.4674 12.3893 -5239 4 22.3242 21.3752 37.157 2.6693 1.87465 3.04951 -5240 4 21.708 20.0203 37.0255 -6.20277 -25.1527 -1.47337 -5241 6 18.4792 41.0219 0.672743 -35.2491 -25.3697 -26.4792 -5242 4 17.5363 41.1592 0.451811 6.2729 -6.09178 6.10687 -5243 4 18.7532 41.8934 0.847545 18.5165 37.9853 8.81983 -5244 6 41.3458 41.7141 25.1818 17.8335 14.8146 -1.57438 -5245 4 40.8444 40.9381 25.3951 -6.7286 -20.9895 5.67055 -5246 4 41.5773 41.6158 24.2546 -2.61686 2.51709 -2.2804 -5247 6 27.6337 28.128 3.93443 68.2433 49.922 -72.4808 -5248 4 27.747 28.0641 2.90056 -5.60951 6.59214 55.905 -5249 4 26.974 27.5707 4.19301 -60.7891 -51.6503 16.466 -5250 6 18.2766 10.5218 31.4985 31.6557 -13.945 -4.11948 -5251 4 17.4661 10.038 31.5755 -21.8827 2.32902 1.26527 -5252 4 18.1351 11.463 31.4681 -8.30794 8.79106 3.21692 -5253 6 11.3047 37.9513 14.7719 14.2766 22.5792 8.51892 -5254 4 10.8196 37.2524 14.3384 -3.55752 -10.2024 4.33151 -5255 4 11.8722 37.607 15.4977 -19.1201 -2.12261 -16.4117 -5256 6 0.810718 18.1323 27.5767 30.9572 19.3393 -0.702274 -5257 4 0.190255 17.4711 27.3024 -13.6082 -17.9307 4.12615 -5258 4 1.6652 17.6816 27.7433 -15.3641 2.36995 -0.952151 -5259 6 36.7957 10.7342 20.2882 16.9593 17.0847 7.18326 -5260 4 36.2525 10.0089 20.0111 -13.8544 -11.0907 -5.31633 -5261 4 36.5766 10.8708 21.2175 -0.466777 -2.92115 4.06643 -5262 6 47.4269 25.5204 8.035 -8.77625 7.04012 -26.0141 -5263 4 47.2351 25.672 7.07342 16.0738 -5.10236 26.6147 -5264 4 46.6031 25.1946 8.38488 -7.38433 -0.0309169 8.21918 -5265 6 13.9121 35.1279 15.9963 57.6206 21.904 15.8158 -5266 4 13.18 34.6338 16.2776 -41.6081 -30.4219 4.97616 -5267 4 13.8612 35.4714 15.1124 -11.7278 3.29634 -19.5683 -5268 6 29.56 35.3617 16.1847 -46.2751 8.28104 -14.7299 -5269 4 30.2098 34.9035 16.6971 16.3841 -9.08849 15.1595 -5270 4 28.6495 34.9755 16.3324 34.0842 8.73794 -6.93478 -5271 6 29.4892 25.8842 32.4194 -24.256 -10.4352 -29.1805 -5272 4 28.8256 25.7516 33.0892 -1.91161 2.59937 23.0953 -5273 4 29.0388 25.4531 31.6468 24.6149 5.96309 7.68736 -5274 6 24.1242 2.12171 25.4449 33.2745 25.8541 -21.7468 -5275 4 24.4973 2.84525 24.8288 -6.14236 -31.0627 26.9036 -5276 4 24.7925 1.39916 25.5361 -16.9688 12.032 -10.1501 -5277 6 4.54733 34.4389 19.1463 -35.302 -7.10976 -3.39284 -5278 4 4.35486 34.5879 18.2161 16.9971 0.874352 -7.12679 -5279 4 3.63202 34.4395 19.5005 25.743 -3.14875 11.9651 -5280 6 10.1206 17.2361 14.3164 8.36708 -29.6599 -28.3251 -5281 4 10.306 17.5039 15.1955 -0.106022 16.7729 24.4966 -5282 4 9.5035 17.8022 13.8616 -7.59249 10.3925 2.01091 -5283 6 21.4437 41.7724 34.6698 -12.6382 -8.67476 11.1219 -5284 4 21.3209 41.1297 35.367 19.1323 -10.7035 11.8578 -5285 4 20.52 0.052046 34.4982 -0.738196 4.11389 -17.598 -5286 6 36.1618 24.1149 12.6039 -38.5184 -29.276 -18.6614 -5287 4 35.5274 23.7914 13.2897 25.4622 4.78071 -2.2183 -5288 4 35.751 23.7447 11.7708 17.6549 15.9976 15.8112 -5289 6 49.5813 18.6026 19.9424 19.3655 4.31785 -3.79274 -5290 4 50.05 19.3681 19.5461 -11.4841 -9.87428 2.01803 -5291 4 50.2881 17.9408 20.0283 -8.44417 3.53865 1.64593 -5292 6 1.24663 7.05846 14.4912 39.2605 -25.8072 -27.0237 -5293 4 1.83321 6.85564 13.6734 -27.5618 7.792 37.3713 -5294 4 1.40902 6.33035 15.1313 0.69425 14.6008 -10.3474 -5295 6 12.7431 22.7725 31.2519 -28.0711 -22.2846 -24.537 -5296 4 12.731 22.0484 30.5842 -1.03989 14.4355 17.1556 -5297 4 13.6361 23.0601 31.2889 29.0982 7.61123 0.941905 -5298 6 8.17623 18.6217 27.8167 28.4831 -7.95646 -20.137 -5299 4 8.40342 17.6669 27.8028 -7.19499 14.8132 8.92302 -5300 4 8.90402 18.9943 27.2753 -13.5351 -1.9306 8.34595 -5301 6 52.1398 28.0368 15.3061 -5.99984 -2.63203 -6.56281 -5302 4 52.212 27.4921 14.5152 3.50742 -7.1981 5.43712 -5303 4 52.1344 28.9249 14.9274 -1.52971 -5.17654 6.68842 -5304 6 52.6974 21.8977 10.081 -19.9085 6.90605 5.3514 -5305 4 53.3388 22.3376 10.626 19.2735 6.64212 5.60719 -5306 4 52.8023 22.3165 9.21858 0.448532 -1.39229 -3.54893 -5307 6 22.3312 5.79987 2.67028 14.2956 -6.96789 22.7666 -5308 4 22.4342 5.66665 3.62826 -7.95027 2.50856 -4.24886 -5309 4 22.7763 5.02131 2.34757 -2.68692 -18.1597 -17.0707 -5310 6 15.4178 16.2178 21.8878 29.1139 16.3559 -34.9346 -5311 4 14.4763 16.1482 22.0206 -17.0561 3.51129 1.66656 -5312 4 15.5967 16.6295 20.979 -16.1676 -12.6325 35.129 -5313 6 28.6996 41.2944 33.8986 -0.299799 0.972013 4.01662 -5314 4 28.6528 40.5712 34.5346 5.69191 -6.81028 -1.89437 -5315 4 27.7925 41.4039 33.5788 7.00998 2.71453 4.16387 -5316 6 9.0271 31.2603 18.2166 -24.0632 3.5617 9.69965 -5317 4 9.00312 32.2249 18.3215 -0.833429 -0.795431 1.49639 -5318 4 8.39564 30.8695 18.8792 23.5138 4.17381 -14.686 -5319 6 20.5401 20.4009 18.1765 -9.82111 13.5354 -7.0052 -5320 4 21.0961 20.6619 18.9088 6.00228 -1.57494 14.3732 -5321 4 19.8969 21.1451 18.1138 9.42471 -20.4088 -2.28899 -5322 6 53.9632 14.7108 37.8185 38.9936 -13.777 37.4998 -5323 4 53.5065 15.4999 38.0588 -19.2143 21.2037 -5.62994 -5324 4 53.6553 14.2856 37.0504 -18.643 -5.89619 -29.3657 -5325 6 28.9005 15.3805 18.8553 43.4355 2.75939 -10.7082 -5326 4 29.8744 15.2601 18.5577 -43.1698 -4.30042 15.6378 -5327 4 28.8821 15.3937 19.8257 1.95554 -2.72042 -0.550014 -5328 6 2.00757 25.8231 18.9102 1.56834 13.1457 16.4238 -5329 4 2.16994 26.6099 18.3718 5.10623 3.14141 1.15535 -5330 4 1.76535 25.1325 18.3092 -5.75322 -15.1157 -18.9078 -5331 6 53.2586 40.7003 24.294 -3.95682 23.2035 5.10337 -5332 4 53.3627 39.7881 24.0333 10.577 -13.1769 -1.30533 -5333 4 54.0929 41.151 24.0537 -8.8009 -7.19084 1.91562 -5334 6 47.531 32.0044 22.8424 -9.22212 4.73076 14.8806 -5335 4 47.3777 32.6735 23.5302 -5.63931 6.65432 -9.88941 -5336 4 48.2144 31.4763 23.2497 9.41484 -5.26157 -3.09765 -5337 6 24.6289 26.1478 33.0175 -22.0968 -9.02062 -12.6011 -5338 4 24.4656 25.5474 33.7557 -1.10221 8.12594 5.97613 -5339 4 25.4283 26.6445 33.1202 14.9272 4.196 4.65224 -5340 6 21.3417 17.0876 39.4763 -6.70912 6.89414 0.748051 -5341 4 22.0272 16.5901 39.8927 14.9242 -9.38388 2.18929 -5342 4 20.9728 17.5957 40.2063 -4.43123 6.71259 -1.60026 -5343 6 11.0417 40.4515 17.0271 -4.84825 -47.9733 -31.3307 -5344 4 11.617 41.1325 17.3235 21.4854 16.9952 0.793724 -5345 4 11.529 39.8797 16.3454 -22.439 27.66 32.3414 -5346 6 20.3522 21.2696 39.8718 -25.2322 13.8952 23.2629 -5347 4 20.7065 20.9823 39.0558 13.3567 -12.8249 -34.1322 -5348 4 21.0787 21.2544 40.4999 1.2931 1.07094 1.93889 -5349 6 2.11891 29.6947 22.5962 -10.9271 -4.15175 -1.48688 -5350 4 1.41229 29.0196 22.6861 11.0269 1.69063 -12.8134 -5351 4 2.97173 29.2673 22.4434 -6.16143 -1.40449 -3.11444 -5352 6 36.756 30.301 35.4561 22.3149 -30.6991 6.56967 -5353 4 36.1659 29.9908 36.1617 3.98829 10.9575 -2.82389 -5354 4 37.5905 29.761 35.5884 -25.1141 24.4323 0.251817 -5355 6 12.9563 4.31922 37.9158 -41.9162 -7.49401 17.923 -5356 4 12.213 3.67486 38.0016 27.2031 5.98064 4.05536 -5357 4 12.5797 5.11915 38.3509 20.8388 -3.72048 -10.4757 -5358 6 38.3368 5.25882 18.4553 -27.9454 13.7946 -11.1943 -5359 4 37.494 5.12162 18.8921 -4.17763 4.09508 -3.9191 -5360 4 38.9486 5.03087 19.1262 32.9808 -9.34357 19.7422 -5361 6 10.4991 9.23341 21.7308 -20.3579 1.12747 21.1104 -5362 4 10.1476 9.35811 22.629 -2.53412 -6.58654 -7.03761 -5363 4 11.4429 9.27697 21.8681 13.0367 -0.194449 -11.5952 -5364 6 0.510441 41.039 17.3204 -22.411 45.8537 -1.19125 -5365 4 1.10275 40.3438 17.515 21.9532 -27.5034 12.6219 -5366 4 0.955429 41.8901 17.5577 -0.403404 -22.4144 -8.21181 -5367 6 4.11028 5.06714 6.43108 -32.0559 -10.673 -25.0156 -5368 4 4.76196 4.43778 6.68194 21.2279 -22.0503 -6.17775 -5369 4 4.3376 5.79555 6.94869 8.69612 42.0455 26.6358 -5370 6 11.4527 25.4042 0.173069 -8.87291 20.1751 -4.43043 -5371 4 11.3037 26.302 0.51034 -2.48968 -2.12098 1.34892 -5372 4 12.3912 25.256 0.330533 -7.09022 -12.0676 2.67745 -5373 6 7.43008 21.5598 8.10589 6.84767 -16.7382 -30.018 -5374 4 7.67559 21.2373 7.18738 -12.1375 12.6211 33.8068 -5375 4 8.24892 21.8626 8.52003 -6.07298 -1.72571 -6.46698 -5376 6 47.5896 16.3642 25.2431 -28.5582 13.6976 -25.6498 -5377 4 46.6075 16.1608 25.1822 37.2389 5.55574 -4.66364 -5378 4 47.8562 16.8152 24.3682 -3.16196 -14.4146 40.515 -5379 6 30.9292 19.5125 39.8483 -41.4217 8.94898 -20.4144 -5380 4 31.859 19.4188 40.0164 22.9308 8.40553 1.58818 -5381 4 30.7224 20.3633 39.3589 16.5857 -27.3682 15.8932 -5382 6 20.3871 24.0387 39.4036 8.00795 23.2793 -8.75093 -5383 4 19.459 24.1701 39.2693 -20.2994 13.2523 2.58474 -5384 4 20.4244 23.1071 39.4874 5.50164 -36.2952 5.14995 -5385 6 45.8871 21.2471 41.1655 20.5283 25.7578 0.477301 -5386 4 46.6385 21.2626 41.7552 1.12624 -15.6366 20.1575 -5387 4 46.1812 21.9667 40.5962 -14.858 0.0662744 -14.6758 -5388 6 32.5732 28.1983 30.4559 17.8923 -19.7368 14.2663 -5389 4 32.9661 27.3096 30.6426 -14.7491 22.8943 -8.37245 -5390 4 33.2232 28.8091 30.8453 -8.57676 -1.81844 -4.53088 -5391 6 18.0207 1.32021 27.0363 -34.7874 1.53884 20.0911 -5392 4 17.0721 1.60205 27.1202 27.3864 -5.2263 -11.315 -5393 4 18.3294 1.50373 27.9381 11.4124 1.84961 -11.8648 -5394 6 39.378 24.9761 21.8758 -21.83 -3.15726 3.51608 -5395 4 39.2925 25.9351 21.9975 13.0773 -1.30024 -1.60914 -5396 4 38.5262 24.6687 22.2439 10.6836 3.42961 -4.87158 -5397 6 33.5904 21.3057 22.0908 0.876878 23.3779 1.34154 -5398 4 32.7037 21.4589 21.7601 -6.64994 -10.6299 -4.35651 -5399 4 34.0298 22.1428 21.8479 4.87062 -13.8873 3.79153 -5400 6 40.1162 15.0006 15.7553 -16.7667 -72.1851 -56.1125 -5401 4 39.3246 14.5665 15.2764 38.6699 22.9899 20.5541 -5402 4 39.7685 15.7046 16.224 -23.0828 51.553 35.6364 -5403 6 32.7063 17.9241 6.36312 -6.65812 28.0098 -27.693 -5404 4 32.6631 17.3286 7.08836 -4.96405 -26.2659 23.6138 -5405 4 32.2202 17.5402 5.61621 0.349997 -9.22032 2.43078 -5406 6 50.4717 15.9308 31.1336 -57.0185 -34.1342 43.3708 -5407 4 51.2677 16.1483 30.7347 55.5832 16.4654 -29.6643 -5408 4 50.5499 15.0059 31.4683 -2.42192 20.1529 -11.8828 -5409 6 23.8292 29.3322 31.6407 10.3974 -8.56959 5.42825 -5410 4 23.7096 29.6981 30.7618 4.3803 -0.813234 -2.10966 -5411 4 24.6813 28.8378 31.6594 -15.3785 13.3689 -4.34977 -5412 6 25.0524 41.6477 38.2806 4.00174 7.46449 -31.3583 -5413 4 25.6511 41.367 37.5454 -10.3054 -0.491554 23.0497 -5414 4 24.5276 0.474703 37.8884 8.98972 -6.87862 14.9811 -5415 6 14.3299 25.4693 7.99598 -51.8246 -23.5651 26.6357 -5416 4 15.0301 25.7523 7.4663 39.147 18.3395 -31.3738 -5417 4 13.6749 25.0466 7.38907 19.2382 9.49844 7.52052 -5418 6 17.2117 20.7467 5.34291 -12.6959 30.9635 29.5807 -5419 4 17.5658 20.2645 4.6512 13.3362 -42.6322 -45.6451 -5420 4 17.6752 21.5763 5.21476 -4.76461 12.1014 12.8322 -5421 6 18.8578 10.961 23.7113 11.9098 -52.6755 14.4862 -5422 4 18.5821 10.3312 23.0139 -2.7304 18.9854 0.947207 -5423 4 18.7069 11.8432 23.4586 -8.32501 34.3086 -18.4054 -5424 6 7.80658 41.3805 11.0401 -9.04392 11.0606 6.15122 -5425 4 8.00429 40.5098 11.4059 2.67644 4.01258 -4.23655 -5426 4 8.51691 0.066 11.3394 -1.81513 -7.16892 -1.05394 -5427 6 48.6966 23.1832 34.0648 -27.3561 -6.76338 -18.0805 -5428 4 48.0792 22.9132 33.32 19.6766 11.2437 24.8207 -5429 4 49.5669 23.23 33.6693 11.2336 0.854645 -6.12438 -5430 6 53.7246 23.5588 15.3422 -2.2993 4.88061 -38.5045 -5431 4 54.0115 23.9686 14.4981 1.04624 9.96871 20.6807 -5432 4 53.2132 22.8493 14.9574 -7.54922 -9.79714 16.7607 -5433 6 22.2409 5.63035 9.83732 -4.74687 0.990813 -28.4051 -5434 4 21.8007 4.9012 9.36518 5.41421 2.33681 17.3637 -5435 4 22.5704 6.16354 9.07597 -3.08255 -9.23766 25.1176 -5436 6 33.6677 8.38805 9.07277 4.65141 2.45263 2.68713 -5437 4 32.9476 8.96499 9.32099 -11.143 10.7473 10.4723 -5438 4 33.4213 8.08448 8.2012 2.38155 -0.0587928 -10.5973 -5439 6 47.3188 37.7205 20.3441 15.215 11.7573 -25.0114 -5440 4 47.5704 37.5879 19.4187 8.2864 3.06637 8.88956 -5441 4 46.6261 37.0853 20.3703 -21.7602 -22.9037 19.9419 -5442 6 30.8605 16.7391 10.6102 -28.0995 -48.2853 23.2284 -5443 4 30.4428 17.1675 11.4048 8.00556 -5.70758 -17.8294 -5444 4 30.5213 15.7576 10.5828 6.17084 54.1408 -3.58748 -5445 6 48.1227 27.723 10.1192 -17.271 38.6552 19.8549 -5446 4 48.941 27.5885 10.6019 15.4404 -6.10886 -7.64033 -5447 4 47.9667 27.1056 9.42146 1.69339 -23.2576 -13.9441 -5448 6 27.3465 38.6397 25.5972 -19.3603 -43.7567 25.3821 -5449 4 28.2552 38.3171 25.6348 3.73027 6.4174 -6.06634 -5450 4 27.3175 39.4354 25.1025 9.7616 28.5552 -11.1584 -5451 6 33.3485 5.72785 21.4502 -30.5322 15.1217 -10.2054 -5452 4 32.7106 6.21453 20.8566 24.3968 -18.0484 15.2917 -5453 4 34.2142 6.02589 21.2258 21.3261 10.3595 -12.9949 -5454 6 25.3097 5.14436 4.52462 -12.6707 -6.42781 10.7366 -5455 4 25.8166 5.03621 5.34324 9.24373 -0.000563512 -7.52253 -5456 4 24.4109 4.89546 4.80865 9.45245 1.955 -8.20101 -5457 6 40.4804 35.6472 19.1595 -4.18239 -17.2552 -25.1441 -5458 4 40.6473 35.1871 19.989 -0.677015 6.66802 10.9293 -5459 4 40.3876 36.5867 19.2889 2.08163 9.85771 9.62751 -5460 6 49.6466 30.6357 19.0258 14.8172 21.4531 -43.5404 -5461 4 50.0494 29.991 18.4245 -6.82309 -11.6442 2.45506 -5462 4 49.4912 30.1943 19.8303 -8.11919 -24.8089 39.0949 -5463 6 42.1414 28.3198 17.0336 30.9261 -8.96587 16.5499 -5464 4 41.9014 28.1134 16.1233 0.612516 -1.09878 -6.61247 -5465 4 42.9986 27.8356 17.2327 -32.0588 11.6021 -17.9905 -5466 6 47.7009 24.529 36.3602 12.6164 -10.6945 -29.4467 -5467 4 46.9511 23.9476 36.4057 -12.614 -6.01445 14.1932 -5468 4 48.02 24.3175 35.4647 6.89481 1.31964 6.68358 -5469 6 19.3487 26.9773 19.8132 -7.91098 29.1703 -3.69101 -5470 4 19.5772 26.0513 19.7652 -2.42994 -17.6971 2.90599 -5471 4 18.7132 27.1892 20.5145 5.94626 -13.5516 -3.80193 -5472 6 47.0594 26.8038 37.5124 29.171 -27.35 55.5912 -5473 4 46.5442 27.3901 37.0243 -28.7601 35.2651 -40.4696 -5474 4 47.4575 26.1126 36.9775 -8.83233 1.8809 -11.4479 -5475 6 9.306 24.6801 40.2841 31.4937 0.109789 0.329283 -5476 4 9.78189 23.9102 39.8717 -14.0424 16.7407 17.3327 -5477 4 10.0272 25.2082 40.7306 -19.6308 -16.1327 -14.1874 -5478 6 14.4855 17.9139 14.2735 23.8217 -2.3356 -5.96097 -5479 4 13.7756 18.1909 13.6871 -0.445295 3.10639 3.20472 -5480 4 15.2926 17.8532 13.6969 -24.9099 1.36359 15.4275 -5481 6 37.1333 38.6708 18.7289 9.24178 15.507 -32.6939 -5482 4 36.7257 39.5382 18.5851 -4.02817 -0.227247 6.07181 -5483 4 37.6697 38.5833 17.9067 -2.91955 -11.3843 16.172 -5484 6 11.4153 5.92336 21.4477 15.4675 -15.5323 24.3843 -5485 4 12.0347 5.46444 22.0611 -14.8481 11.1792 -11.8992 -5486 4 10.9828 5.22117 20.955 -5.02219 -4.37746 -7.57367 -5487 6 4.24672 30.7112 16.2271 25.0754 -37.7862 10.5022 -5488 4 4.05441 31.4608 15.7204 -4.71706 34.9582 -31.1175 -5489 4 3.72964 30.8334 16.9988 -11.892 -2.06994 24.4228 -5490 6 17.6689 16.0105 27.0706 -11.532 -19.4613 -16.5334 -5491 4 17.475 15.0322 27.0999 0.550485 29.0366 -12.0979 -5492 4 17.2014 16.3875 26.2691 10.8221 -16.0252 20.0561 -5493 6 36.4979 8.6445 40.4253 22.1182 5.90925 -1.87084 -5494 4 36.6649 9.56092 40.6574 -3.64727 2.10984 0.486612 -5495 4 35.6642 8.36755 40.7885 -12.5441 -1.64485 2.44437 -5496 6 13.6104 12.9476 3.01337 -0.796658 -1.76047 52.4558 -5497 4 13.281 12.534 3.85665 2.0295 3.09436 -35.1239 -5498 4 14.3672 13.4568 3.35498 1.79634 -1.71495 -16.7359 -5499 6 38.5663 20.1511 21.6276 16.2684 -2.59448 10.3838 -5500 4 39.225 20.3435 20.957 3.66548 0.723189 -1.42015 -5501 4 37.7399 20.1987 21.178 -26.4348 -4.9091 -11.1397 -5502 6 51.0002 10.2707 30.836 -20.0759 -41.5967 21.7358 -5503 4 51.4945 11.0341 30.626 15.2265 30.1997 -10.6067 -5504 4 50.365 10.1656 30.1217 2.42758 1.75416 -9.76943 -5505 6 16.2768 2.44039 41.3342 24.5898 23.894 -47.9169 -5506 4 15.7659 1.68969 41.4668 -26.4768 -52.1654 31.458 -5507 4 16.2309 2.46185 40.3616 9.12406 8.41144 7.6857 -5508 6 16.5823 4.96192 41.8916 -4.82165 52.2801 -70.6027 -5509 4 16.7504 4.9538 0.881833 10.2709 -3.72182 62.3109 -5510 4 16.3825 4.09214 41.6138 -6.48385 -26.7637 5.90228 -5511 6 38.2132 37.6512 20.9834 35.6931 -0.0015793 9.16781 -5512 4 38.1132 38.2158 20.1985 1.71026 -5.63736 5.42755 -5513 4 39.175 37.679 21.2752 -35.8773 5.52261 -11.9395 -5514 6 27.3063 1.90932 15.7743 -36.1781 7.04456 22.02 -5515 4 27.5288 1.21363 15.1745 3.62804 -9.29946 -19.0329 -5516 4 26.3092 1.89423 15.8276 27.8398 0.929522 -3.41863 -5517 6 29.0129 12.4346 37.8081 29.6396 -2.3639 23.3235 -5518 4 29.5703 13.228 37.8521 -9.25731 3.38449 -11.2245 -5519 4 29.432 11.8866 38.5178 -20.735 6.92768 -10.3763 -5520 6 46.0725 20.1624 18.9069 6.39102 14.9163 -14.6323 -5521 4 45.1723 20.516 18.8892 1.91785 -0.379773 0.405435 -5522 4 46.587 20.7656 18.3221 -3.54001 -13.7442 9.74416 -5523 6 2.03634 38.6845 18.4933 3.82981 -3.85695 21.6638 -5524 4 2.81563 38.6864 19.0472 23.4807 10.2435 -12.678 -5525 4 1.45125 38.3557 19.1766 -27.1945 -1.99387 -8.3623 -5526 6 44.0469 24.9707 25.966 7.80173 10.6441 20.9452 -5527 4 44.2747 24.0363 26.0952 1.37736 2.33249 -4.33209 -5528 4 43.5784 25.0701 25.1359 -3.49858 -7.6437 -6.59112 -5529 6 5.98346 26.6137 4.53144 23.0758 4.04073 24.4329 -5530 4 6.55391 27.1627 5.13089 -15.1794 -12.3526 -15.6845 -5531 4 6.29729 25.6938 4.67268 -13.7287 18.2257 -9.78447 -5532 6 0.087877 23.2081 10.934 24.9145 3.46447 1.10559 -5533 4 0.685292 23.7315 10.3726 -8.08066 -2.01306 3.92681 -5534 4 0.721975 22.7627 11.5282 -19.4067 -0.934622 -1.78644 -5535 6 39.1228 20.6282 12.8796 23.5823 -4.01912 3.74068 -5536 4 40.0483 20.9095 13.1274 -25.2182 -11.8294 -4.75086 -5537 4 38.9288 21.0058 12.0111 3.51405 8.21934 1.48951 -5538 6 39.9585 39.9542 18.8548 8.25477 7.63818 -34.14 -5539 4 39.6086 40.5348 18.1328 12.8912 -23.3113 16.3656 -5540 4 39.4227 40.1355 19.596 -22.4924 5.25798 25.9214 -5541 6 49.2764 23.011 30.5163 -3.77364 -44.6036 15.8547 -5542 4 49.4289 23.7872 30.0082 18.6126 30.182 -14.9565 -5543 4 49.9621 22.8706 31.1946 3.66181 18.5012 -4.70792 -5544 6 10.3518 2.34263 9.13761 -0.60969 70.0656 33.4022 -5545 4 10.2194 1.51752 8.76453 -19.3013 -48.5596 -30.1763 -5546 4 9.57958 2.95755 9.02478 16.8019 -18.7251 -1.57756 -5547 6 9.61453 40.9339 19.7468 19.8516 -54.9951 -16.0575 -5548 4 9.63195 40.6865 18.7859 0.317082 16.3896 20.6195 -5549 4 10.0376 40.0904 20.1458 -24.9194 43.0231 -10.2629 -5550 6 29.2525 5.10109 17.4961 7.67774 22.6856 2.90325 -5551 4 29.0408 4.77134 16.6193 -6.82779 -3.03985 -6.7526 -5552 4 29.5295 6.02934 17.3335 -2.58265 -16.5067 4.76001 -5553 6 27.0985 15.4102 3.23556 -13.4453 -81.1273 -7.3603 -5554 4 27.3652 16.2806 3.27349 18.8182 67.1491 11.283 -5555 4 27.7776 14.8512 3.68225 -14.3437 21.6428 -0.863725 -5556 6 32.8444 39.3852 25.121 -7.01244 -52.8845 44.4676 -5557 4 32.5131 40.2222 24.9368 -10.8075 51.8916 -16.2411 -5558 4 32.4445 39.2315 26.0289 16.1191 -0.874654 -30.671 -5559 6 34.9513 7.88207 31.2328 20.4504 58.5219 2.42802 -5560 4 34.2036 8.45679 31.498 3.65199 -12.2289 -1.35309 -5561 4 34.6861 6.99719 31.2488 -20.0023 -44.0519 1.25651 -5562 6 6.12467 36.7605 26.1486 23.5936 30.152 20.8626 -5563 4 6.61267 37.4751 26.6609 -18.7565 -29.2185 -15.3031 -5564 4 6.64666 36.6639 25.3566 0.873799 -8.15108 -9.63468 -5565 6 6.01736 25.8242 24.1032 -23.71 11.4997 43.6127 -5566 4 6.27054 25.4519 24.9889 5.69321 0.899098 -34.3464 -5567 4 5.25039 26.3671 24.4036 11.002 -12.3451 -22.9516 -5568 6 45.616 24.3868 2.54557 6.93899 11.9467 -1.18645 -5569 4 46.5025 24.2318 2.18535 0.269069 -11.0786 2.08994 -5570 4 45.6283 24.2142 3.48441 5.93067 -6.10702 12.3332 -5571 6 15.5106 11.7053 32.6869 22.7313 15.5035 25.4621 -5572 4 15.7644 12.551 33.1413 -9.31293 -24.2108 -12.4541 -5573 4 14.956 11.9719 31.9681 -12.2379 8.7831 -14.7046 -5574 6 46.4141 17.7037 37.4783 -24.8433 -42.9552 -46.1347 -5575 4 46.5841 17.8832 38.3706 6.4658 9.03355 44.3658 -5576 4 46.0203 16.778 37.4148 6.08678 36.5836 2.96135 -5577 6 39.713 20.917 18.528 13.2313 30.5311 40.8197 -5578 4 40.433 20.5782 18.0298 13.2747 -18.0123 -24.5712 -5579 4 40.2054 21.5165 19.1543 -30.2447 -12.7963 -15.6911 -5580 6 23.8051 28.0334 36.6648 -18.7533 17.1228 48.8478 -5581 4 23.301 27.37 37.1661 8.15196 -5.41595 -20.5023 -5582 4 23.699 28.7533 37.3439 14.557 -4.10395 -29.4534 -5583 6 23.235 0.659798 30.8906 16.7198 -34.3804 0.301059 -5584 4 23.3562 41.8891 31.5781 -2.93034 5.1259 -1.85649 -5585 4 23.9222 0.433479 30.2226 -16.4688 10.6885 3.12481 -5586 6 37.1438 6.89027 28.2945 -2.75708 2.50278 32.0481 -5587 4 36.7625 6.23385 28.9496 14.7229 22.3106 -21.8828 -5588 4 37.4874 7.65333 28.8474 -13.0775 -21.14 -18.6628 -5589 6 3.23769 6.61111 12.3846 0.723209 -17.9385 -9.61551 -5590 4 2.93962 6.7917 11.4726 6.04883 11.0603 10.3219 -5591 4 3.59705 5.70622 12.3141 -7.8292 10.6871 9.81534 -5592 6 12.6213 19.1513 31.1215 -11.7593 -39.2703 -9.13055 -5593 4 12.5689 18.1911 31.4279 4.41954 36.1073 -0.401864 -5594 4 12.3049 19.0952 30.1995 4.23471 8.33584 13.9505 -5595 6 15.1895 38.3194 41.5508 -8.26313 0.106571 5.96729 -5596 4 15.4027 38.685 40.6867 1.58925 3.7734 1.08261 -5597 4 15.977 37.8419 41.8199 8.82113 -1.67422 -0.112624 -5598 6 49.6344 33.3417 19.6414 -43.1776 -42.2962 -0.847743 -5599 4 48.6794 33.3996 19.9697 35.2792 3.84356 -17.7841 -5600 4 49.66 32.3974 19.2778 11.8172 40.1309 17.1575 -5601 6 6.36572 2.78375 29.9004 1.05055 15.8156 -22.8281 -5602 4 6.36575 3.75042 29.7262 1.90425 -15.9719 7.25575 -5603 4 5.96593 2.68858 30.7619 0.24665 -4.47807 16.8647 -5604 6 13.1696 31.768 30.2754 -6.44409 10.1839 -14.6274 -5605 4 12.7931 32.0108 29.386 8.00869 -8.49993 19.6421 -5606 4 12.9985 30.8211 30.4317 -1.17466 7.15103 -3.10169 -5607 6 32.315 32.2433 24.9103 28.3535 -13.0924 -48.465 -5608 4 32.6582 31.5201 24.3183 -18.8106 4.4732 28.5514 -5609 4 32.6906 33.004 24.4312 -3.21058 9.63112 20.1287 -5610 6 42.0003 14.5628 37.421 -39.889 12.6212 -8.37855 -5611 4 41.095 14.1415 37.3281 37.9102 -1.96214 -0.320241 -5612 4 42.7025 13.9066 37.3517 -4.02931 -15.6388 2.60245 -5613 6 11.8892 7.23447 27.6701 3.45884 -4.12236 4.5236 -5614 4 11.8415 6.40302 28.2109 -4.80024 17.2153 -14.4092 -5615 4 11.297 7.16355 26.8983 -0.411327 -9.99206 8.34553 -5616 6 14.2054 37.5349 6.88535 -5.50304 -50.1586 -23.8091 -5617 4 14.4448 38.4425 6.82842 11.1201 34.2121 -5.16838 -5618 4 14.5404 37.0855 6.04727 -8.45912 19.5264 31.302 -5619 6 14.2389 30.7101 36.0658 7.9951 22.3707 -6.00421 -5620 4 14.3369 30.7582 35.119 5.20948 5.89711 -15.5268 -5621 4 14.162 29.7856 36.1796 -2.50712 -40.828 17.27 -5622 6 16.4199 33.6465 5.49971 39.8982 -12.4718 -37.0106 -5623 4 16.8881 34.472 5.38053 -10.1033 13.7438 12.8324 -5624 4 16.9383 33.116 4.82328 -31.4907 -2.1142 22.2677 -5625 6 23.0347 17.1509 7.84843 -2.98061 53.305 10.417 -5626 4 22.2528 17.4913 7.37616 0.35347 -20.1342 1.7373 -5627 4 23.3535 18.0122 8.2624 2.91922 -40.8936 -9.01863 -5628 6 51.739 20.8998 27.7117 45.1346 -9.91933 19.8422 -5629 4 51.4539 20.5938 28.5983 0.576611 5.87017 -14.8878 -5630 4 52.7517 20.9693 27.7878 -43.3794 -0.870523 -11.1135 -5631 6 2.19386 27.6013 28.8077 21.9852 1.77593 -20.6905 -5632 4 2.90112 28.2633 28.7865 -8.94698 7.25322 21.5481 -5633 4 2.57794 26.9939 28.1568 -21.2327 -10.3447 8.82052 -5634 6 17.2209 14.3445 7.70498 -9.6153 -40.0176 25.3709 -5635 4 16.7414 14.2178 8.5755 19.2823 5.01031 -25.0594 -5636 4 17.7242 13.4894 7.54274 -12.7499 32.9606 1.11211 -5637 6 12.4553 8.94194 14.7093 23.4905 -30.5738 22.1451 -5638 4 12.3295 7.96561 14.6517 -10.6336 18.1935 -14.5798 -5639 4 13.0902 8.95069 15.466 -13.8235 22.031 -14.7981 -5640 6 42.4163 38.0607 9.75492 -41.3892 12.3524 0.930734 -5641 4 43.2155 37.8504 10.1985 23.5031 -2.65638 19.8551 -5642 4 41.8128 38.5249 10.3845 19.1619 -5.0707 -9.72644 -5643 6 51.8291 30.3524 28.2725 -23.4976 -15.3182 24.0858 -5644 4 51.4769 31.1806 28.0071 -16.9091 20.9854 -6.54852 -5645 4 52.5669 30.2698 27.7075 37.0459 -10.0857 -13.876 -5646 6 0.173291 18.5306 4.58887 -6.78508 26.3933 6.63194 -5647 4 0.366643 18.0957 3.77581 2.61413 -8.62723 -27.1515 -5648 4 0.528197 17.9664 5.25604 0.668563 -20.2899 17.5992 -5649 6 34.1542 0.618182 3.01035 -64.6642 7.59467 -29.5426 -5650 4 33.2756 0.91071 2.55681 38.9521 -14.8268 28.0312 -5651 4 34.8139 1.0189 2.46529 20.392 14.9436 -5.19898 -5652 6 49.1703 17.2445 23.163 11.3421 -28.7232 -23.3687 -5653 4 50.0948 17.5226 22.997 -11.4987 -1.8789 7.34388 -5654 4 49.1149 16.3391 22.7575 3.35316 27.0342 8.27414 -5655 6 23.1508 6.50484 23.6205 15.3745 23.1125 -33.0506 -5656 4 23.1854 7.14565 22.8174 -14.1016 -25.0292 28.8988 -5657 4 22.2566 6.27815 23.8868 -11.3625 11.3028 -1.57795 -5658 6 11.0777 24.0866 29.2726 3.42799 -14.5151 -26.2344 -5659 4 11.3051 23.4915 28.5104 -10.7193 12.1306 15.2701 -5660 4 11.7189 23.8646 29.9475 6.00027 1.59973 10.1126 -5661 6 36.5499 4.08922 21.6769 -9.80126 5.87302 -21.3361 -5662 4 36.3976 4.50823 22.521 3.21878 -0.144303 13.033 -5663 4 36.3054 4.80832 21.0596 6.63301 -13.9203 1.83546 -5664 6 31.3023 25.6432 24.5943 15.0376 6.85795 28.0728 -5665 4 31.291 26.2789 25.3519 -12.6017 -14.5788 -25.478 -5666 4 32.0941 25.1064 24.7955 -9.59576 -0.449362 -7.93794 -5667 6 42.6065 23.029 14.7662 -46.2562 -12.0705 -53.1337 -5668 4 42.8654 23.3474 13.8766 8.33796 6.77145 13.2285 -5669 4 43.1929 23.285 15.4255 44.8404 21.8098 38.991 -5670 6 14.3111 11.6689 8.88632 -19.0153 -23.9468 -21.906 -5671 4 13.3495 11.3817 8.87766 31.9146 14.5471 0.24728 -5672 4 14.742 11.0378 8.25313 -7.14597 12.5116 20.7778 -5673 6 21.4992 2.13393 3.40246 8.36864 -2.88126 -9.61958 -5674 4 22.4231 2.22963 3.69686 -12.58 -3.45743 -2.69439 -5675 4 21.4721 1.34946 2.81138 2.62282 6.56171 18.4043 -5676 6 22.4667 27.6841 39.0793 -16.1771 -11.2193 -33.3168 -5677 4 22.9487 28.2311 39.6723 13.8114 13.1168 21.0188 -5678 4 22.2331 26.8853 39.529 -0.753476 -8.75647 11.2468 -5679 6 37.2752 33.5075 30.0534 -5.09816 -29.8969 21.2662 -5680 4 36.5321 32.9121 30.2938 11.1992 13.6878 -5.37502 -5681 4 38.0391 33.1092 30.5204 -9.59535 7.6329 -11.7718 -5682 6 41.8356 20.8755 40.0084 -30.1785 -26.2846 -15.3963 -5683 4 40.891 20.6843 40.2338 21.7839 7.55089 -6.55796 -5684 4 42.213 21.2736 40.7728 12.4306 8.07023 23.0746 -5685 6 10.0585 31.1051 22.2503 24.8691 -18.1602 32.094 -5686 4 10.0242 30.9652 23.2199 -0.323131 -4.21186 -18.2592 -5687 4 9.26251 31.5457 22.0526 -32.5358 14.9165 -12.561 -5688 6 24.2061 35.3797 6.65176 29.8647 -7.74501 -52.0461 -5689 4 23.2981 35.13 6.46942 -12.5131 3.59528 11.7489 -5690 4 24.436 35.6291 7.5325 -13.5066 3.92126 26.0938 -5691 6 54.2205 13.3707 18.7548 -14.8606 0.23157 2.49876 -5692 4 53.5905 13.2954 18.0026 12.0308 5.79113 16.3195 -5693 4 53.7072 13.5032 19.578 4.97112 -2.65932 -16.1217 -5694 6 12.4895 25.0856 17.4479 -5.54126 21.12 19.6166 -5695 4 12.0527 25.8035 17.9613 1.96295 -15.4272 -10.9144 -5696 4 12.9797 24.5872 18.1192 -7.22993 -2.38631 -13.5888 -5697 6 22.3914 33.9622 18.8899 -17.7941 -3.8788 -25.186 -5698 4 22.7777 34.3519 18.0802 1.20341 3.55679 12.7761 -5699 4 21.5828 33.5138 18.532 26.0363 5.82114 13.25 -5700 6 24.4442 12.917 5.83205 -1.35281 -9.13891 6.68087 -5701 4 24.5112 13.8355 6.04562 11.139 23.8521 5.95609 -5702 4 23.7978 12.9208 5.12829 -4.38592 -8.75699 -5.70796 -5703 6 13.4045 11.2384 28.602 -9.94106 -32.5269 -0.345522 -5704 4 13.7125 10.4202 28.1467 1.06973 22.7078 1.68844 -5705 4 12.6883 10.856 29.1417 2.50959 12.0169 -5.49025 -5706 6 20.9681 34.6931 21.1354 15.1203 14.42 -6.16036 -5707 4 21.5009 35.1121 21.8248 -8.94458 -7.77672 4.1779 -5708 4 21.5063 34.8208 20.3262 -11.2236 -10.4562 8.09593 -5709 6 37.1336 34.5207 26.1541 -9.5297 -36.7224 -3.07541 -5710 4 37.2109 34.2142 25.2288 3.21082 15.1766 11.7274 -5711 4 37.5352 35.3664 26.2639 8.9577 18.3348 -6.65469 -5712 6 49.3622 27.1182 23.4746 39.7066 -11.0301 13.9767 -5713 4 48.4746 27.3502 23.3119 -43.65 9.96054 -8.06751 -5714 4 49.6716 26.7458 22.6451 -3.30563 -9.15784 -7.68388 -5715 6 2.6564 41.733 27.6477 -1.65257 -10.3676 0.180548 -5716 4 2.5349 41.5868 26.6785 2.71482 14.5166 10.808 -5717 4 3.44733 0.360291 27.8573 -13.8821 -2.9337 -13.5775 -5718 6 28.2538 5.65865 0.855763 -50.2522 -11.1502 7.99105 -5719 4 29.1126 5.92525 0.635025 43.8938 8.11388 -11.2713 -5720 4 28.2366 4.68907 0.832778 5.05155 4.08711 2.73992 -5721 6 46.3376 19.9476 30.6448 -5.32264 7.02196 22.3264 -5722 4 46.9473 19.8004 29.9179 3.84913 9.17517 -5.42643 -5723 4 46.6125 20.7672 31.1318 -5.12963 -19.3092 -16.4827 -5724 6 3.64577 25.7701 21.5553 -12.766 27.4814 -12.397 -5725 4 3.72382 24.8593 21.8343 3.84868 -9.88757 -5.52558 -5726 4 3.13913 25.8588 20.7173 13.2009 -15.3518 9.10855 -5727 6 2.75122 19.0968 29.6319 -2.61118 -0.882922 8.96218 -5728 4 3.5891 18.6871 29.8565 3.14038 -9.81989 10.1431 -5729 4 2.90737 19.4327 28.7602 3.1882 14.1904 -12.7773 -5730 6 11.8953 35.7778 24.2646 -23.8517 23.4638 0.926703 -5731 4 12.2722 34.9198 24.2954 23.5909 -23.1933 0.784725 -5732 4 12.5229 36.3761 23.8548 12.2449 3.68762 -3.83655 -5733 6 52.3409 30.3775 14.3038 25.9342 24.3497 3.27132 -5734 4 52.8186 31.1218 14.7277 1.28259 -10.3571 -1.87569 -5735 4 51.5459 30.7912 14.0165 -25.7225 7.74731 -5.34623 -5736 6 0.083662 24.3704 32.1159 7.87696 -1.86575 0.949534 -5737 4 0.925887 24.7254 31.8116 -7.58302 1.2158 -10.0766 -5738 4 0.064605 24.6797 33.0182 -11.6947 5.89195 12.8097 -5739 6 31.4941 23.7355 38.8139 13.6067 4.55671 22.3988 -5740 4 31.5922 23.3599 39.6955 6.6148 17.5079 8.63317 -5741 4 30.9989 23.0266 38.4646 -21.4094 -18.5611 -29.2329 -5742 6 52.1193 21.6104 3.49599 14.6151 -31.0847 -13.388 -5743 4 52.9641 21.5934 2.99085 -20.8635 4.42776 5.19501 -5744 4 52.1025 22.4297 3.95509 1.85636 27.8943 8.87727 -5745 6 31.7523 33.9412 11.6017 9.59211 -24.6365 -8.99112 -5746 4 31.343 34.2459 12.4067 -7.95657 10.1636 10.9534 -5747 4 32.0734 33.0348 11.7994 -4.73133 20.193 -2.42319 -5748 6 7.03486 17.6719 16.6685 29.0057 -41.5114 -49.367 -5749 4 6.91092 17.0215 17.3537 -7.78637 4.64801 28.8113 -5750 4 7.29826 17.0034 15.9319 -18.9591 50.1453 28.7374 -5751 6 51.8542 41.8728 22.1898 10.246 17.2442 -13.5357 -5752 4 52.3028 41.4443 22.9054 19.3182 -6.61148 18.5368 -5753 4 51.1068 41.3135 22.0792 -27.0964 -11.4612 -2.03348 -5754 6 50.8737 9.93347 25.9376 -32.929 -21.31 0.307119 -5755 4 50.6075 10.0984 25.0351 -2.54905 2.45869 -5.94774 -5756 4 51.7134 10.3221 26.0527 29.2363 20.0336 5.9403 -5757 6 9.00178 39.8723 13.8451 -19.3622 -18.1235 -30.983 -5758 4 9.55792 39.3182 14.3856 9.60602 -5.37935 8.26515 -5759 4 8.70771 39.29 13.0873 14.4347 20.6992 23.854 -5760 6 40.6986 25.5526 0.136544 19.9096 -17.3535 33.0343 -5761 4 40.3666 25.3638 1.04053 0.834228 7.76146 -13.9079 -5762 4 41.6521 25.7245 0.296606 -16.7956 -8.725 -14.7957 -5763 6 46.6823 7.83196 22.8561 10.1499 25.8504 33.9562 -5764 4 46.2788 7.49308 23.6743 -2.78909 -8.0392 -13.1915 -5765 4 47.099 8.65892 23.1926 -4.50937 -8.82075 -14.1875 -5766 6 20.9875 12.9068 9.95805 -11.691 32.2034 24.7109 -5767 4 21.4351 12.3054 10.5167 21.854 -26.8991 22.1196 -5768 4 21.3309 12.7465 9.11062 12.4417 -9.66517 -44.3579 -5769 6 24.8453 0.514421 28.6038 13.082 22.7197 -2.81433 -5770 4 24.715 0.071792 27.7548 -6.16819 -1.63374 -2.91335 -5771 4 25.0442 1.45997 28.4028 -6.72102 -19.281 3.08734 -5772 6 9.94041 22.6855 8.28517 -18.2906 18.759 -35.6321 -5773 4 10.3442 21.9586 7.83344 17.071 -18.1108 1.7387 -5774 4 9.60436 23.1702 7.48056 7.13277 7.40532 33.7222 -5775 6 33.2759 9.25429 23.8257 8.37106 -55.2845 13.9355 -5776 4 33.3237 10.1123 23.4806 -1.26345 47.1757 -20.4798 -5777 4 34.1087 8.81977 23.5578 -8.47821 6.16632 5.2483 -5778 6 47.7984 20.3614 34.2959 -41.6158 20.0741 -32.6301 -5779 4 47.162 20.9095 33.7523 35.4977 -6.5354 18.8426 -5780 4 47.2264 19.5923 34.4121 13.8381 -6.37745 11.1074 -5781 6 7.49292 13.4971 41.09 9.79805 -11.8131 -23.6679 -5782 4 7.49901 13.1324 40.1715 -6.0705 12.8605 17.5951 -5783 4 8.32745 13.1637 41.4633 -5.36906 3.36653 2.36319 -5784 6 9.96112 23.6102 1.61114 1.89646 0.256416 -8.05524 -5785 4 10.3422 24.1467 0.893187 3.70522 0.0162214 12.766 -5786 4 9.63217 22.8308 1.16111 -2.5861 -8.4474 -3.4617 -5787 6 27.3279 14.1675 11.3384 -16.3978 3.93745 18.7515 -5788 4 27.0565 14.7974 10.6584 -0.154384 0.736593 1.51299 -5789 4 26.9739 14.5213 12.1957 15.9081 -3.44829 -24.7787 -5790 6 25.8416 31.7729 17.8867 -18.6075 -57.137 -13.4601 -5791 4 26.5498 31.1652 17.5816 -7.88637 19.42 8.67928 -5792 4 26.1364 32.6121 18.1157 31.0786 47.9057 11.8145 -5793 6 28.5054 34.3394 0.220618 54.67 33.5077 11.5224 -5794 4 29.0324 33.8757 0.885908 -4.94848 -3.20805 0.921423 -5795 4 27.711 33.8992 0.092994 -46.8158 -31.9819 -6.78258 -5796 6 39.4821 27.6754 22.7241 37.6977 26.8974 -34.7457 -5797 4 38.562 27.8477 22.7631 -35.1425 8.51836 6.28403 -5798 4 39.8483 28.4606 22.2037 -4.4779 -30.5719 17.4824 -5799 6 19.3989 35.5068 37.6449 44.7238 7.00696 26.241 -5800 4 18.7939 34.9286 37.217 -17.2642 -20.3375 -13.2178 -5801 4 20.0787 34.9056 38.0699 -27.4009 15.1777 -18.4057 -5802 6 40.2622 30.2205 10.7395 23.7464 -4.20556 -44.2191 -5803 4 39.872 30.2327 11.5724 -12.5687 -7.32393 56.9787 -5804 4 39.6265 30.6987 10.2193 -5.46151 14.1383 -16.826 -5805 6 44.8252 28.4803 36.0885 -55.5401 -40.4399 48.4955 -5806 4 44.0914 27.9458 36.6324 49.8455 26.3412 -39.6007 -5807 4 44.7386 29.3482 36.4954 11.2485 4.05282 -13.3799 -5808 6 17.9305 13.9374 34.278 5.37655 43.1893 -39.9004 -5809 4 17.3503 14.7126 34.0365 12.4853 -29.216 13.3111 -5810 4 17.5732 13.4499 34.9957 -23.6035 -11.4222 25.4792 -5811 6 22.772 11.7897 25.9182 -5.92321 66.9234 -24.4623 -5812 4 22.4079 10.9608 26.1065 -2.80798 -46.2844 14.8143 -5813 4 23.7282 11.8442 25.9391 13.2658 -20.917 3.34216 -5814 6 27.9678 31.9745 40.3581 9.67064 -3.036 11.5355 -5815 4 28.3415 32.7469 39.952 3.83939 12.9153 -6.44865 -5816 4 27.8423 31.3481 39.6454 -9.64166 -7.41544 0.62615 -5817 6 29.7189 5.14175 29.7003 46.1252 -36.6163 -19.9261 -5818 4 29.2969 5.47215 30.4671 -15.8461 16.6952 32.1509 -5819 4 30.5834 4.69597 30.0017 -39.473 23.5261 -13.8417 -5820 6 3.10812 21.482 2.76797 0.178067 -30.2305 -7.76436 -5821 4 2.88389 22.394 2.68207 -8.68283 21.8462 0.431797 -5822 4 2.52465 20.9987 2.15107 4.11904 7.00085 10.9335 -5823 6 13.6455 30.6616 39.7413 -31.0251 6.24286 -53.6991 -5824 4 14.4958 30.9276 39.9901 40.59 7.52955 18.7737 -5825 4 13.6028 30.9637 38.7781 -13.7388 -14.6365 40.9566 -5826 6 39.1879 23.0833 28.2631 23.8153 34.0131 -40.8644 -5827 4 39.3603 23.1915 27.276 -9.32936 -4.03115 31.7012 -5828 4 38.6771 22.3028 28.3825 -19.3689 -24.2853 3.44718 -5829 6 16.9942 23.7475 0.782551 23.2332 -11.0525 -6.02825 -5830 4 16.1835 23.4907 1.22514 -0.204047 -3.07314 3.44284 -5831 4 17.6924 23.1245 1.11262 -18.9135 18.2649 -2.71213 -5832 6 0.34625 33.6655 13.0265 -29.0282 32.855 38.2597 -5833 4 54.9333 33.1158 13.7076 7.16186 -20.0974 -8.4449 -5834 4 0.196186 34.5312 13.5136 21.864 -23.0202 -35.8666 -5835 6 49.1134 40.6592 16.9502 -22.6074 7.13526 -12.7963 -5836 4 49.0929 41.0585 16.0481 9.95068 -10.3513 11.1088 -5837 4 48.1763 40.6949 17.2078 7.5264 3.31219 -3.37923 -5838 6 52.1371 39.9932 15.179 23.5783 8.13152 6.60826 -5839 4 51.9212 40.0798 16.1068 2.92809 -1.65288 7.91558 -5840 4 51.3496 39.6649 14.7978 -27.1925 -6.99882 -20.2103 -5841 6 29.0492 37.0934 37.8397 27.862 0.580994 -15.5106 -5842 4 29.7824 36.6456 38.29 -13.83 -0.942856 -3.03347 -5843 4 28.3401 37.1923 38.4583 -14.8343 8.34268 17.6028 -5844 6 4.87483 1.47389 27.5722 8.99005 1.78018 0.412076 -5845 4 5.18955 1.04652 26.7639 -2.94161 4.65408 6.15856 -5846 4 5.65876 1.67721 28.1054 -5.69693 -0.488114 1.02013 -5847 6 43.5905 24.3648 30.2005 -22.2044 -15.6763 19.9702 -5848 4 44.3573 23.9419 29.8442 19.8319 -9.6252 -11.3654 -5849 4 42.9995 23.6287 30.4468 4.54232 11.3491 -5.57307 -5850 6 33.7546 3.53169 22.9281 6.20171 -10.3572 -20.5792 -5851 4 34.1788 2.72522 22.5548 -7.61164 22.2296 6.95503 -5852 4 33.66 4.19918 22.2026 -0.715781 -19.232 19.3758 -5853 6 19.8847 13.4579 25.4063 -13.0952 -9.58357 -31.6265 -5854 4 20.5464 14.0819 25.6574 14.0517 10.8301 14.4774 -5855 4 19.8633 12.7253 26.0209 8.35596 -5.88238 10.9252 -5856 6 47.3765 23.175 39.6238 -8.62258 12.6683 8.16714 -5857 4 47.7656 22.5263 39.0394 4.03481 -11.1372 -12.2265 -5858 4 47.7314 24.026 39.3382 2.38196 -1.35255 2.76448 -5859 6 20.1792 18.6695 32.3892 10.8118 -11.8558 9.82813 -5860 4 19.7451 19.3837 31.9609 -18.6549 15.8768 -14.4176 -5861 4 21.1063 18.8885 32.2904 5.57481 -8.22146 4.6255 -5862 6 0.469489 5.80056 25.6694 -18.1951 25.8664 -34.3154 -5863 4 0.192512 6.63022 25.2132 12.4788 -26.9708 -4.90825 -5864 4 0.599388 6.15564 26.5295 8.98284 3.20038 34.2611 -5865 6 6.87796 19.5502 31.9212 -30.9469 28.3562 -15.4034 -5866 4 6.36899 19.9719 32.666 7.94508 -11.3044 -26.1662 -5867 4 6.51823 19.9652 31.058 21.1032 -17.2362 32.6466 -5868 6 6.72006 20.2763 38.5282 -5.5716 11.964 -18.9783 -5869 4 5.89143 20.7831 38.5761 11.8801 -4.42879 -4.55199 -5870 4 6.91977 20.0675 39.4366 -2.33705 -6.77268 4.9945 -5871 6 22.0131 25.9408 12.2669 -3.54377 -45.9259 -44.7125 -5872 4 21.4169 25.4251 11.6232 6.06411 36.0021 36.1209 -5873 4 22.8575 25.5519 12.0003 5.79029 4.70211 8.19546 -5874 6 39.2956 7.94468 2.64777 3.93347 -3.54621 1.69719 -5875 4 39.6192 7.96721 3.55942 2.89932 9.4301 1.57912 -5876 4 39.5223 7.0665 2.33247 5.57505 -8.53159 -3.65477 -5877 6 29.9733 22.0379 34.4029 6.80249 8.99144 -26.5663 -5878 4 30.9486 21.9114 34.4332 -22.6925 2.47334 -4.63229 -5879 4 29.7282 22.2324 33.4511 1.23467 -5.29722 31.1857 -5880 6 37.585 16.2896 0.378862 9.66072 -32.1652 -13.4334 -5881 4 37.1738 15.3958 0.469359 7.4986 19.6703 2.82788 -5882 4 38.3979 16.0784 41.7811 -5.81955 5.34443 7.8674 -5883 6 11.7199 13.8969 21.9024 0.976022 -4.28814 -52.9061 -5884 4 11.762 13.5091 20.9636 8.25344 3.74313 41.2159 -5885 4 11.7301 13.2111 22.5694 -0.197866 -18.3587 0.721586 -5886 6 33.3547 10.9227 27.6206 7.79028 2.98821 -12.2755 -5887 4 32.7398 11.5851 27.2614 8.9286 -8.03905 3.2582 -5888 4 34.0693 10.7866 26.9485 -19.1033 10.7299 13.3482 -5889 6 30.9479 36.5351 10.0985 1.61282 -58.9885 -21.8283 -5890 4 31.0506 36.3975 9.1055 -4.33965 11.8991 35.1417 -5891 4 31.0192 35.5887 10.4601 -6.41155 39.3119 -7.26857 -5892 6 45.5784 6.55949 25.24 49.1938 -13.828 -6.30557 -5893 4 44.6777 6.5515 25.5065 -25.461 -8.09624 7.65514 -5894 4 45.978 5.64009 25.2752 -26.9592 28.1751 -0.0529727 -5895 6 9.53089 30.0259 12.0468 18.203 -29.4993 -35.3826 -5896 4 9.87965 30.5113 11.2809 1.8895 2.86193 6.03312 -5897 4 9.26134 30.6784 12.652 -18.7794 25.6859 27.1844 -5898 6 53.0787 24.9761 1.37462 5.70131 11.5656 52.3682 -5899 4 52.7701 24.171 1.02302 -14.9871 -27.078 -25.8882 -5900 4 53.2426 25.5756 0.676612 4.18045 17.0305 -26.7636 -5901 6 26.1794 24.7359 0.502901 22.1176 -25.6344 -30.1555 -5902 4 25.7034 24.7594 41.5454 1.42755 5.35042 26.0986 -5903 4 25.8798 25.3805 1.12222 -18.0425 21.9232 11.274 -5904 6 23.006 2.41877 11.549 3.03835 0.786733 -23.201 -5905 4 22.1232 2.19651 11.8728 1.75899 -1.65202 1.96434 -5906 4 22.9163 2.42328 10.5701 -3.31062 2.24291 13.1011 -5907 6 29.9286 12.8953 30.9894 2.56623 -0.427284 6.89615 -5908 4 30.7531 12.7948 31.5295 -11.6926 9.48208 -25.7239 -5909 4 30.1452 13.1242 30.0532 3.97045 -7.90132 21.6369 -5910 6 24.0654 16.1863 40.3478 -8.57837 -16.1993 -7.0618 -5911 4 23.8181 16.8167 40.9886 -17.7345 17.1107 43.7161 -5912 4 24.4461 16.799 39.7307 8.03288 -6.21636 -19.956 -5913 6 21.8775 29.9129 12.7438 8.38993 20.3936 0.69825 -5914 4 21.1101 29.6022 12.2761 -16.411 -9.00989 -4.05561 -5915 4 21.7959 30.8814 12.6689 6.66677 -10.3308 5.74649 -5916 6 45.2196 12.276 6.62528 -23.2047 44.1078 30.1736 -5917 4 45.4494 11.529 6.11864 16.0879 -27.9404 -20.133 -5918 4 45.9267 12.944 6.63915 -2.18395 -9.27911 -10.7446 -5919 6 7.59043 25.3914 38.0243 42.7544 -18.087 21.3587 -5920 4 8.2454 25.1294 37.3073 -28.6085 13.3538 22.5553 -5921 4 8.06078 25.1795 38.9036 -17.5445 13.8955 -36.9473 -5922 6 46.1702 7.81994 16.6869 -21.8749 40.0263 -11.2018 -5923 4 46.5308 7.86296 15.7811 2.96678 -6.7279 9.6444 -5924 4 46.6568 7.20863 17.2067 24.29 -27.7199 6.2944 -5925 6 54.9712 12.8519 7.72645 -5.0392 -7.84126 -11.592 -5926 4 54.9715 13.8156 7.65436 -3.45199 -1.13943 9.08655 -5927 4 54.3111 12.5688 8.37934 8.51313 12.0297 -0.864167 -5928 6 26.936 39.6495 37.1759 1.87165 14.912 18.6021 -5929 4 27.6928 39.6002 36.5592 -3.34619 -10.0228 14.3716 -5930 4 27.1866 39.3914 38.108 -0.832196 -0.678219 -33.4669 -5931 6 27.0349 8.92218 38.0169 24.6524 -2.61622 -28.7715 -5932 4 26.316 9.52058 38.1337 -23.9094 17.4181 8.51603 -5933 4 27.4852 9.31616 37.2255 -4.7843 -14.0734 18.554 -5934 6 8.05135 7.65161 29.9116 12.1299 -7.94147 21.2544 -5935 4 8.62851 7.92802 30.6495 -6.35395 -5.29094 -12.0163 -5936 4 7.74814 8.47335 29.5547 -5.2558 18.4649 -14.2469 -5937 6 27.8737 27.8565 12.1051 -38.6038 15.3188 22.9885 -5938 4 27.4445 28.7122 12.3849 14.7215 -19.9621 -4.23437 -5939 4 28.6312 28.0341 11.5799 28.6137 10.9177 -18.1106 -5940 6 23.5548 30.5037 38.1558 -29.4871 -31.9475 26.5081 -5941 4 24.0962 30.758 38.9126 3.93335 7.76671 -5.43794 -5942 4 23.9417 30.8351 37.3772 21.2145 16.4773 -23.4003 -5943 6 48.0793 24.306 17.3344 -19.3615 12.8085 -14.3801 -5944 4 47.2872 24.7421 17.7455 27.359 -7.68532 -3.4425 -5945 4 48.1537 24.7387 16.4546 -0.580236 -6.90317 13.1114 -5946 6 38.498 5.30294 40.3305 40.7021 23.5094 2.62433 -5947 4 38.9475 4.64687 39.7972 -10.9193 -18.4764 2.07144 -5948 4 39.1882 6.01706 40.3225 -28.8653 -3.92995 8.38836 -5949 6 31.2337 3.92695 33.7301 -2.6422 16.6026 -6.87478 -5950 4 31.7948 4.28658 33.0166 -2.97898 -8.44373 7.32517 -5951 4 31.5298 3.03423 33.9266 10.3473 -9.06319 -0.444766 -5952 6 41.2426 8.81864 38.1104 -4.47266 -7.82466 24.3448 -5953 4 41.0373 8.41451 38.9755 -2.01902 1.52645 -10.1427 -5954 4 41.1368 9.75783 38.3095 7.23604 3.04516 -5.74389 -5955 6 53.3619 29.0937 24.5785 -40.2757 11.297 7.14485 -5956 4 52.5565 28.5537 24.7901 26.871 10.2044 -0.818821 -5957 4 52.9453 29.9599 24.3491 20.4755 -15.9472 -3.03 -5958 6 54.9044 15.544 40.7081 25.545 -57.3548 17.1629 -5959 4 54.9892 16.405 40.3633 -12.4948 43.2864 -12.4113 -5960 4 54.018 15.2891 40.9908 -7.57666 14.2468 -5.0348 -5961 6 46.3994 17.0672 31.8767 -6.245 16.1286 -17.5712 -5962 4 46.5114 17.9797 31.5283 3.34232 -11.2714 9.55259 -5963 4 45.8128 16.6602 31.1996 2.74349 5.02824 21.6551 -5964 6 36.898 25.0477 23.0493 11.3229 21.4084 -39.4528 -5965 4 37.2029 24.9737 23.9235 7.13326 -1.42781 43.2733 -5966 4 36.3025 24.3424 22.8486 -15.8402 -9.5757 6.36085 -5967 6 11.3692 4.41343 15.9249 15.7896 22.4119 -17.7964 -5968 4 11.3725 3.62473 15.3598 -3.28732 1.6252 14.2587 -5969 4 11.7055 5.11941 15.3214 -6.01385 -9.48847 12.8461 -5970 6 12.7845 7.07125 19.464 -10.6801 6.56169 22.7508 -5971 4 12.8604 6.27981 18.9655 14.1597 -21.8558 -24.6024 -5972 4 12.2771 6.71627 20.2197 6.8185 19.6013 -8.61559 -5973 6 12.0681 33.6471 17.5522 -1.52085 -17.496 -42.1785 -5974 4 11.9445 34.1189 18.3508 -6.25092 12.897 34.2466 -5975 4 12.5251 32.8183 17.7704 2.9394 6.95993 4.68875 -5976 6 10.2419 4.74292 2.55933 22.7613 10.361 1.71337 -5977 4 9.42389 4.50476 2.9876 -9.73314 -9.75152 7.74431 -5978 4 10.9687 4.12007 2.82053 -14.8261 2.90481 -11.2179 -5979 6 4.58785 36.8771 12.1606 -7.79451 -50.5455 -28.0593 -5980 4 4.4315 37.6675 12.6216 -0.588552 45.9766 17.7929 -5981 4 5.40236 36.9214 11.6472 0.781205 5.58305 7.99313 -5982 6 30.7591 35.3322 25.8391 -38.6972 -6.70904 -25.8809 -5983 4 31.308 35.3014 26.6139 2.09136 -3.6723 11.5509 -5984 4 29.8922 34.8696 26.0006 25.0535 4.09477 3.57125 -5985 6 20.1826 7.15897 1.87495 42.3449 13.1453 -15.8992 -5986 4 20.9155 6.54161 2.14653 -26.0098 16.5163 -6.36728 -5987 4 20.7109 7.92751 1.4772 -24.8109 -25.5601 12.7141 -5988 6 21.7554 6.89613 28.9929 -8.55274 -2.37394 -9.1913 -5989 4 22.0764 7.2366 29.8207 3.60587 3.07422 19.5812 -5990 4 22.5251 6.52709 28.5653 7.82832 -0.878326 -6.51175 -5991 6 6.87782 37.1389 6.94163 -1.13334 10.8563 13.3375 -5992 4 7.36847 37.9928 6.7949 -15.2779 -15.8129 7.53623 -5993 4 6.56156 37.0941 7.87645 12.8328 8.43507 -22.3513 -5994 6 37.1951 18.3599 16.3051 31.8484 54.3956 -63.0636 -5995 4 36.5686 18.6502 16.9278 -28.3708 4.63663 38.6073 -5996 4 37.3394 19.2548 15.8115 -3.93301 -42.965 18.1753 -5997 6 52.3874 25.498 31.3134 14.111 8.09505 3.74503 -5998 4 52.2596 26.4307 31.6656 16.8187 -33.1452 -9.3176 -5999 4 53.3531 25.244 31.2999 -24.6813 13.8962 6.4969 -6000 6 3.93514 39.8328 16.38 27.5969 -10.0907 -6.6773 -6001 4 3.11618 39.8354 16.8714 -5.56329 -11.6849 3.14974 -6002 4 4.25813 38.8985 16.2148 -16.7217 35.1377 3.93655 -6003 6 26.055 14.6352 18.3097 2.48745 23.0231 -5.4837 -6004 4 27.0121 14.5315 18.422 -4.58232 5.3017 0.111087 -6005 4 25.8831 15.6122 18.2324 0.591934 -25.1482 1.36918 -6006 6 22.1861 39.625 23.6336 -13.0035 -7.16992 22.0669 -6007 4 22.5756 40.4198 23.3178 20.0241 20.7615 -16.9022 -6008 4 21.775 39.9577 24.4575 2.36146 -17.5943 -7.81238 -6009 6 5.9827 12.8747 22.3739 5.28791 3.19174 -0.347139 -6010 4 6.16079 13.1981 21.4813 -0.557605 -0.80783 -0.954564 -6011 4 6.85402 12.6686 22.7296 5.64669 -4.60509 -1.11135 -6012 6 48.9358 28.1656 34.7093 -34.12 -15.1013 -7.57113 -6013 4 48.3009 27.4712 34.4428 -1.24475 21.7165 7.07681 -6014 4 49.7483 27.6911 34.6564 33.1581 1.27133 3.59264 -6015 6 7.76665 22.4378 33.2356 5.82113 4.36953 2.134 -6016 4 7.99414 22.0593 34.0982 -2.05459 -3.4103 -7.93698 -6017 4 7.15982 21.8587 32.7652 -2.05153 -2.03416 7.79212 -6018 6 41.0903 39.5994 11.7192 28.8485 25.6095 5.96672 -6019 4 40.6961 40.3697 11.3388 -29.9964 5.48828 -17.7316 -6020 4 41.854 40.0697 12.1081 -2.33823 -21.5528 5.66509 -6021 6 26.8801 37.922 39.3457 -9.67122 -13.15 30.7983 -6022 4 27.1418 37.9976 40.2903 -3.7646 7.48977 -14.0985 -6023 4 25.9915 37.5069 39.4007 11.6973 7.1772 -10.1587 -6024 6 16.8317 41.5399 16.7862 15.0313 6.40425 17.7164 -6025 4 17.5506 0.178386 16.4567 -5.24562 -1.69226 -13.3924 -6026 4 17.0965 41.4441 17.7156 -14.9292 -9.12078 -7.2801 -6027 6 19.02 8.9948 17.6728 1.01249 -20.0254 27.6053 -6028 4 18.8256 9.92734 17.8397 -2.50665 -0.780218 3.94781 -6029 4 19.0722 8.45531 18.5284 1.63313 22.2167 -34.6872 -6030 6 31.0993 24.379 20.1031 -5.45136 7.30173 -0.0135243 -6031 4 30.58 24.6604 20.88 7.69136 -4.59203 -13.2888 -6032 4 31.7465 25.0718 19.9526 0.652083 2.88804 -0.364555 -6033 6 24.6121 6.3117 27.596 -14.2942 3.47042 8.51555 -6034 4 24.6855 6.72112 26.7154 0.000835906 -11.6728 3.52597 -6035 4 24.4562 5.35726 27.5796 2.29956 0.742888 -9.80031 -6036 6 11.6309 5.33579 8.21245 48.3472 17.5789 -13.0214 -6037 4 10.7447 5.097 8.35577 -43.9811 -8.24091 9.59422 -6038 4 11.6324 6.14291 7.66014 -5.62825 -15.0071 6.92232 -6039 6 16.4828 34.2339 17.2467 58.9453 43.3211 -11.1422 -6040 4 15.833 34.737 16.7643 -22.9367 -4.06405 -2.05249 -6041 4 17.323 34.8225 17.0684 -41.083 -49.3458 15.3182 -6042 6 40.7431 40.4645 8.52128 12.2314 -11.8005 -21.5431 -6043 4 40.0246 40.6751 9.09883 -14.9736 5.2464 12.3608 -6044 4 40.4244 39.6664 8.05294 5.87539 10.603 6.78918 -6045 6 42.7463 5.87875 14.2877 12.74 -3.29305 -3.26541 -6046 4 42.0588 5.87807 14.9272 -15.1719 8.11415 20.4154 -6047 4 42.5132 5.11812 13.7588 -0.0411089 -3.23222 -11.0769 -6048 6 14.3659 21.065 6.06718 -46.5802 14.1632 25.7131 -6049 4 14.5381 21.6726 6.80844 -4.55135 -9.99097 -5.53618 -6050 4 15.2049 20.8313 5.76105 45.2018 -10.2131 -22.6687 -6051 6 16.2987 37.772 18.1217 -43.41 26.7654 24.2454 -6052 4 15.4242 38.2299 18.3727 36.2216 -25.3097 -28.3843 -6053 4 16.6845 37.7048 19.001 13.5629 -5.49997 -6.41318 -6054 6 40.7915 27.7152 27.1158 9.45156 2.81801 -4.91689 -6055 4 41.5456 27.319 27.566 -3.53201 -5.16081 10.0516 -6056 4 41.2155 28.2976 26.4751 -4.07016 3.79859 -1.40954 -6057 6 44.9595 25.9846 14.0499 3.3218 -15.4841 -8.79479 -6058 4 45.329 25.1566 13.6433 -5.22711 26.2877 13.1546 -6059 4 45.4837 26.7406 13.7529 4.37393 -9.76715 -6.45081 -6060 6 2.62066 33.9505 21.2427 -16.9582 -3.86849 -3.69815 -6061 4 2.06211 34.7496 21.3041 9.37305 -3.74186 4.79914 -6062 4 2.1388 33.3568 20.6382 5.47892 10.3925 4.65279 -6063 6 5.77806 4.43691 12.8378 4.70319 28.9306 -8.8144 -6064 4 5.36233 3.72198 13.3221 -5.81749 -8.58488 4.20714 -6065 4 5.80863 5.24637 13.3804 -1.3041 -13.5761 2.8333 -6066 6 16.8665 5.92021 7.40582 23.56 -3.08178 3.03829 -6067 4 16.4354 5.08697 7.20958 -2.89912 -12.7512 -7.28137 -6068 4 16.1638 6.54304 7.4701 -21.737 13.5702 4.65232 -6069 6 17.8259 38.4084 36.8446 -8.45971 28.6621 19.1884 -6070 4 17.7005 39.3712 37.0468 11.155 -18.7052 -15.1769 -6071 4 18.5325 38.3077 36.2071 4.43545 2.51623 -4.89916 -6072 6 43.3084 20.5973 5.4325 -39.7754 20.35 -2.23031 -6073 4 43.0204 21.5105 5.15286 19.9417 -23.843 3.70329 -6074 4 42.4274 20.1471 5.43024 22.0601 -2.53082 1.71294 -6075 6 21.5318 23.3 30.4444 10.3709 20.0389 -42.3415 -6076 4 21.0369 22.9394 31.1576 -20.9289 -4.03021 22.2109 -6077 4 20.911 23.6578 29.7428 10.7798 -15.246 22.7192 -6078 6 0.249866 28.0345 36.1724 -10.1983 37.6035 -27.6546 -6079 4 1.05324 27.7572 36.576 20.3102 -14.8665 16.9966 -6080 4 0.540234 28.832 35.6712 -10.982 -12.5736 6.41543 -6081 6 3.04754 17.0516 11.5683 -6.97145 7.64509 -15.3824 -6082 4 3.16434 17.3061 12.4746 3.36597 -0.550097 20.9912 -6083 4 2.52404 17.7798 11.2137 2.91457 -3.72579 -4.7217 -6084 6 24.1788 37.0366 23.9551 -12.9856 4.64226 12.2764 -6085 4 23.6099 37.826 23.831 6.85326 -8.75197 5.00341 -6086 4 24.4012 36.9865 24.9175 -1.53567 3.17074 -21.6248 -6087 6 3.95494 20.5134 27.4915 2.8093 53.7214 17.1103 -6088 4 3.58105 20.0931 26.7551 -14.7022 -26.8908 -38.8522 -6089 4 3.8118 21.4686 27.2477 5.25372 -20.6261 11.8203 -6090 6 54.8404 2.77723 29.6182 19.2518 19.5174 31.7291 -6091 4 54.8688 2.43537 30.559 -2.71579 12.5717 -24.6672 -6092 4 0.596183 3.44189 29.5911 -17.1059 -25.2514 0.407437 -6093 6 27.1931 8.41834 31.7378 -5.45838 77.4793 -29.1542 -6094 4 26.7872 8.25949 30.8671 -2.01983 -12.8877 1.93898 -6095 4 27.4107 9.43311 31.6496 -7.24897 -56.0438 21.5563 -6096 6 30.967 1.65521 30.3853 -24.4372 0.252197 19.6085 -6097 4 30.699 0.824835 30.0215 -2.04196 -23.8902 -26.6583 -6098 4 30.1085 1.94064 30.7387 6.28416 6.26069 6.0985 -6099 6 26.4053 36.4472 36.8445 23.7132 4.61357 6.55265 -6100 4 26.2095 35.8808 36.1068 -5.45287 -5.64468 -12.8873 -6101 4 27.3732 36.593 36.8324 -14.4493 2.44748 -3.93886 -6102 6 51.2993 10.0458 21.7014 24.6671 -30.2423 2.93053 -6103 4 50.7417 9.318 22.0589 9.26734 22.884 -6.07289 -6104 4 52.1551 9.59094 21.4448 -31.6711 18.7199 5.84467 -6105 6 52.4308 12.3792 23.2584 -6.42579 27.1004 22.8118 -6106 4 51.6946 13.0394 23.3088 16.6887 -7.91574 -6.77392 -6107 4 52.0327 11.5757 22.9611 -11.4365 -20.1199 -14.9439 -6108 6 9.99751 38.3699 20.6117 28.0449 -1.18219 -11.795 -6109 4 9.42862 38.2366 21.3654 -6.81781 0.619005 12.6857 -6110 4 10.9196 38.1916 20.8926 -11.789 -1.89114 -3.31064 -6111 6 22.7111 33.2651 0.632604 -8.26324 25.0772 17.5737 -6112 4 23.6702 33.3984 0.628432 0.752102 -10.2993 -4.51528 -6113 4 22.4939 32.4115 0.275412 2.14165 -18.6843 -11.1325 -6114 6 14.0859 40.8716 25.4956 -8.46488 1.55142 -11.4693 -6115 4 14.0599 40.7138 26.4427 12.1567 0.227551 5.06398 -6116 4 13.2623 40.45 25.1949 6.8133 8.32038 -2.55804 -6117 6 42.7734 15.0947 14.9538 14.4784 5.50426 -3.8277 -6118 4 43.0583 15.7694 14.2817 -8.42225 -24.0175 22.033 -6119 4 41.8405 15.2241 15.1238 -9.70916 3.613 0.791575 -6120 6 30.2327 7.231 8.54228 -3.22532 10.2874 -46.9304 -6121 4 30.2058 8.2102 8.45082 -0.363858 -13.9116 11.7844 -6122 4 30.4404 6.92219 9.39771 6.32383 2.81905 38.5597 -6123 6 3.37293 19.847 41.3038 28.0406 -0.792001 0.268463 -6124 4 3.19157 19.2836 40.5407 -0.0866071 4.98821 -2.30354 -6125 4 4.34764 20.0104 41.227 -24.6382 -4.50526 4.46777 -6126 6 8.87233 25.1482 17.2024 12.9182 -25.3276 -29.7935 -6127 4 8.99656 24.7585 16.2934 -10.9438 23.5455 20.5923 -6128 4 9.70028 24.8859 17.6216 -4.47076 0.166054 9.91948 -6129 6 9.34357 14.9539 22.0324 -26.1912 3.45279 3.87325 -6130 4 9.00509 14.8035 22.9321 4.97494 4.93375 -7.4516 -6131 4 10.1685 14.4775 21.9786 8.71262 0.391972 2.49596 -6132 6 2.03472 4.77693 20.8549 -5.0231 -16.4156 -4.2241 -6133 4 2.70086 5.4497 20.9192 18.9425 7.91266 2.94425 -6134 4 1.28907 5.15394 21.3146 -15.2358 3.90158 4.43282 -6135 6 18.286 7.04631 3.85489 -3.97091 0.415968 51.7005 -6136 4 18.7541 7.10917 3.04736 31.918 9.65669 -29.8899 -6137 4 18.8529 6.48913 4.44789 -12.6499 14.6692 -9.5202 -6138 6 17.0004 19.1661 19.8445 11.8294 -6.56912 -12.2376 -6139 4 17.7808 18.891 19.3473 0.445698 5.6808 3.33406 -6140 4 16.3387 18.5282 19.5337 -1.78106 12.0244 12.6463 -6141 6 4.30992 6.55322 21.357 27.1319 -4.11604 -15.0588 -6142 4 4.37542 6.91771 20.4543 -7.8574 5.76294 11.3657 -6143 4 5.24976 6.29093 21.5457 -28.1422 4.34799 0.417434 -6144 6 20.7778 36.9247 35.6618 12.7574 4.02765 2.49936 -6145 4 20.2864 37.0887 34.8562 -7.2468 0.0429553 -2.15645 -6146 4 20.2346 36.372 36.2389 -2.87094 1.27188 3.61263 -6147 6 4.73067 15.0203 31.2359 -10.2649 -12.7571 22.9725 -6148 4 4.37694 14.8342 32.1428 11.1861 -2.73027 -21.4712 -6149 4 4.72677 15.9733 31.1768 1.84417 11.2425 -7.2724 -6150 6 2.35535 1.23403 17.5726 17.2813 12.9738 -21.7174 -6151 4 3.03402 1.36527 16.8495 -17.2186 -13.1695 22.3246 -6152 4 1.92973 2.10387 17.6452 0.590267 -7.80147 9.6411 -6153 6 34.6252 31.5686 19.7984 -1.60729 -4.66139 0.568696 -6154 4 34.8929 31.9422 18.9439 4.49305 -5.18782 4.12596 -6155 4 34.4714 32.3271 20.3758 -2.9002 2.23803 -3.07041 -6156 6 24.1913 21.6089 13.5036 44.4004 0.328862 15.9674 -6157 4 25.0757 21.8297 13.9142 -30.8821 -6.11275 -18.7564 -6158 4 23.5519 22.0563 14.035 -11.4749 15.2668 7.23318 -6159 6 37.218 41.0972 5.69166 19.5034 -37.5651 -15.7416 -6160 4 37.88 41.7374 5.923 7.59407 13.6828 5.23653 -6161 4 36.3807 41.3769 5.99879 -24.6171 21.3167 5.70938 -6162 6 8.42841 7.99247 20.2345 27.9918 -33.0924 -23.0682 -6163 4 9.34968 8.06233 20.5347 -4.8675 5.92304 8.61954 -6164 4 7.93058 8.66586 20.633 -20.9635 39.4709 23.1164 -6165 6 14.934 18.8758 36.75 17.7625 18.3313 11.0559 -6166 4 14.0949 19.1945 36.41 0.856939 4.31409 -3.77921 -6167 4 15.6034 19.6084 36.7133 -18.5855 -12.9909 -4.44137 -6168 6 43.9791 40.6449 18.6524 7.41508 -0.428335 24.9958 -6169 4 43.9624 40.7544 17.7052 -3.16787 6.2189 -16.8328 -6170 4 44.8981 40.8188 18.9384 -9.62798 -9.77666 -5.30663 -6171 6 33.7986 32.259 37.3472 -15.5926 9.65631 -28.1821 -6172 4 34.0274 32.2295 36.4014 -5.19534 3.83485 15.8105 -6173 4 34.1945 31.4931 37.7276 18.2887 -12.3889 13.4194 -6174 6 5.09973 29.2834 24.0252 13.8314 -2.01249 29.2407 -6175 4 5.66693 29.5091 24.8044 -5.06459 -6.54793 -18.8628 -6176 4 4.76417 30.1245 23.7257 -5.49348 12.2693 -6.11875 -6177 6 33.6015 36.4179 10.971 30.294 2.53226 6.78363 -6178 4 32.7735 36.2836 10.5343 -15.5054 6.45725 -2.01925 -6179 4 33.4383 36.5424 11.9099 -7.56878 -2.98124 3.33663 -6180 6 28.3001 33.6166 13.1114 -3.16981 -41.1231 7.22112 -6181 4 27.986 33.7275 12.219 -4.10441 9.98298 -8.29397 -6182 4 28.0891 32.6746 13.2632 10.0083 14.4728 2.55385 -6183 6 6.1623 19.0624 24.2873 5.31394 -11.2621 -36.8053 -6184 4 5.95503 19.8074 24.8143 -4.51254 28.8134 22.7686 -6185 4 6.28788 18.3114 24.8476 4.1007 -18.6743 20.2695 -6186 6 28.4211 19.9362 1.86305 -4.43245 7.71948 8.08869 -6187 4 28.5604 19.4518 1.05094 6.94613 -11.0067 -8.65768 -6188 4 29.2593 20.0693 2.30859 5.46778 1.78077 -4.74455 -6189 6 42.0505 23.9714 9.55892 6.22877 26.0941 -5.00732 -6190 4 42.391 23.8165 10.4395 -2.03908 -8.00084 11.8727 -6191 4 41.7886 23.1541 9.15249 -7.7641 -22.6922 2.79783 -6192 6 43.5253 7.315 27.4414 4.48568 -18.9578 -0.168547 -6193 4 42.7359 7.07504 27.9388 -6.2009 1.74131 6.88183 -6194 4 43.2052 7.88335 26.7439 -2.31843 16.2411 -9.46916 -6195 6 20.4956 32.9945 9.25625 -63.2008 -2.41398 62.3431 -6196 4 19.7614 32.7323 9.96384 46.0698 -1.29529 -42.5223 -6197 4 20.3338 33.9485 9.24422 8.88758 3.29294 -12.4302 -6198 6 38.0318 35.2729 15.9427 -5.10059 -23.3836 -5.94715 -6199 4 37.3995 34.9842 15.2568 2.89047 3.01243 8.00796 -6200 4 37.9835 34.6007 16.6396 -2.13864 4.37071 -5.14357 -6201 6 47.5248 20.8808 3.95546 13.1177 31.1209 27.8573 -6202 4 48.0834 21.3954 3.36869 -6.69878 -8.89675 -13.1919 -6203 4 47.6052 21.4353 4.7772 -13.2785 -23.1226 -13.8569 -6204 6 10.9875 31.6892 41.4239 15.5099 5.40423 7.74084 -6205 4 11.658 31.8708 40.7529 -4.12469 -5.30401 -0.84079 -6206 4 10.1343 31.6927 40.9879 -7.96504 0.77506 -5.12071 -6207 6 43.245 12.6563 2.56138 15.9633 -17.8577 -2.60545 -6208 4 42.9226 12.9752 3.38765 -12.1061 12.2594 19.7928 -6209 4 43.9805 12.0851 2.8659 -6.2276 8.95994 -12.8364 -6210 6 49.4104 25.4124 21.1593 7.68799 -7.2912 5.83542 -6211 4 50.1422 25.2884 20.5387 -8.96396 0.548785 -4.3756 -6212 4 48.9554 24.5515 21.2297 -0.219253 8.20777 -2.75058 -6213 6 1.96484 34.1377 26.4635 6.42117 -7.58108 12.8955 -6214 4 2.78995 33.6488 26.6876 -20.6965 7.00883 -11.752 -6215 4 1.22498 33.5087 26.4121 8.61724 -1.18295 0.134997 -6216 6 17.1337 20.8362 36.6743 -37.6695 15.6036 21.8376 -6217 4 16.9634 21.7284 37.0778 2.65776 -21.0237 -14.9647 -6218 4 18.0617 20.7108 36.604 32.6572 -5.60583 -3.13187 -6219 6 36.5992 10.9735 3.70439 10.6975 8.82737 -5.2901 -6220 4 35.7369 11.4094 3.76988 -2.71865 -0.136466 14.5734 -6221 4 36.9547 10.7712 4.57736 -11.0261 -1.49358 9.11508 -6222 6 14.2213 20.6732 21.973 14.9521 39.3927 -42.8738 -6223 4 13.9206 20.2439 21.1689 -11.1282 -8.72354 1.45028 -6224 4 14.6851 21.4628 21.5779 -7.13343 -24.0966 22.8635 -6225 6 33.9052 12.2539 9.56536 64.6676 -19.1083 -72.943 -6226 4 34.3898 11.482 9.88615 -11.1791 5.59008 13.1859 -6227 4 33.2619 12.5422 10.1406 -48.1209 12.4396 55.8498 -6228 6 21.8075 41.4938 2.15247 -4.53434 0.170379 -15.7872 -6229 4 22.04 41.6038 1.2069 -3.47083 0.972349 16.0219 -6230 4 22.4007 40.8419 2.51679 12.4955 -1.6466 3.58022 -6231 6 20.9241 10.4413 14.2084 23.7182 11.537 17.3335 -6232 4 21.6155 10.8692 14.7979 -25.0251 -17.572 -17.464 -6233 4 20.772 9.54041 14.5736 6.4121 16.6732 -7.22543 -6234 6 6.25992 4.45494 24.6446 -20.993 10.5392 9.58783 -6235 4 6.70633 4.20365 23.8452 17.869 -10.7134 -15.0213 -6236 4 5.71116 3.71075 24.9084 -2.77077 -5.20552 -8.90983 -6237 6 50.776 14.5967 23.4784 31.7068 8.96229 10.5861 -6238 4 51.3012 15.0259 24.1918 -10.5702 -1.89466 -14.6802 -6239 4 49.902 14.4731 23.8252 -15.4415 -8.6063 7.51113 -6240 6 52.7906 13.9066 9.67243 -4.11462 48.2741 -4.64476 -6241 4 52.8606 13.0389 9.99278 3.823 -46.6932 12.5875 -6242 4 51.8698 14.0585 9.47707 -15.983 -0.946523 -10.048 -6243 6 9.04475 2.0467 29.9184 -38.5307 -30.621 -19.1189 -6244 4 9.46565 2.82007 30.2002 17.3321 39.2201 17.0183 -6245 4 8.08016 2.26538 29.8177 25.0495 -3.86709 2.38687 -6246 6 7.14389 29.9898 26.2407 4.70582 -42.771 12.4286 -6247 4 6.53112 30.404 26.8495 -5.08686 4.52864 3.1398 -6248 4 7.41427 29.1442 26.7142 -2.42767 26.6911 -17.7681 -6249 6 49.1638 41.7413 14.3375 -4.64089 27.4779 2.19815 -6250 4 49.5241 41.3828 13.5134 1.94418 -6.50091 1.47491 -6251 4 49.3811 0.802946 14.3236 2.14399 -30.2019 -5.07663 -6252 6 5.64888 3.82667 19.1906 -2.72189 -11.1411 26.1263 -6253 4 5.18678 3.36179 19.9258 5.23606 10.5823 -14.7259 -6254 4 5.05621 3.82399 18.4509 -7.60985 1.79477 -11.7277 -6255 6 9.32681 35.8274 24.8975 3.55565 13.5922 8.51546 -6256 4 10.2018 35.8152 24.4762 -3.06017 -4.39849 2.56743 -6257 4 9.46171 36.417 25.6586 -3.66837 1.49938 -3.23358 -6258 6 53.0285 29.7558 11.5499 -7.83487 -2.48558 9.64451 -6259 4 53.3653 30.4407 10.9686 7.5475 4.44921 -4.95089 -6260 4 52.7971 30.2083 12.3783 3.5824 -3.07517 -4.75195 -6261 6 22.6104 9.96627 5.67467 11.8622 1.90434 48.3765 -6262 4 23.3836 10.3266 6.15809 -8.36646 -10.9093 -7.81297 -6263 4 22.6398 10.3769 4.83333 -6.21393 7.91547 -32.804 -6264 6 39.5293 19.6134 2.67969 28.3515 9.20962 14.5311 -6265 4 38.5781 19.5068 2.58618 5.24604 -11.8744 -9.9137 -6266 4 40.0367 19.3939 1.87869 -17.6459 -1.04308 -3.70363 -6267 6 45.0742 35.5802 7.80399 12.9966 -1.00157 -13.6899 -6268 4 45.1073 36.2582 8.46111 4.45786 22.5875 10.9896 -6269 4 44.5296 34.9182 8.21469 -15.7495 -15.8794 0.100297 -6270 6 29.7829 14.2459 9.96531 -11.2509 -10.5838 -6.95263 -6271 4 30.0063 14.1556 9.0247 4.7074 -2.26926 1.20969 -6272 4 28.8478 13.9409 10.004 20.3358 11.6689 4.42407 -6273 6 29.2532 30.1489 21.8872 -22.7358 8.41186 19.7293 -6274 4 29.1261 30.8351 21.2312 3.02893 4.58934 -9.48892 -6275 4 30.0577 29.6729 21.7506 17.9631 -9.68935 -13.2514 -6276 6 11.1028 18.8149 6.56446 12.6172 11.1172 -5.75863 -6277 4 11.2898 19.7306 6.3073 -12.9819 2.38317 -1.53669 -6278 4 11.9922 18.4416 6.57196 0.724871 -8.7617 2.86424 -6279 6 13.403 39.1446 13.4748 19.5871 -11.9429 -30.0571 -6280 4 13.7697 39.8507 13.9939 7.8117 10.5151 13.4831 -6281 4 12.6292 38.8582 13.9386 -20.2152 -7.12839 8.32373 -6282 6 50.1432 12.9893 0.138872 33.4511 24.3017 64.4039 -6283 4 49.8497 12.6921 41.2405 -20.6967 -26.8999 -59.7452 -6284 4 50.7523 12.3231 0.503203 -9.52656 2.062 -3.94446 -6285 6 47.8312 31.3446 27.7846 -28.8076 12.8422 -13.2841 -6286 4 47.8833 31.94 28.5222 10.4006 4.03183 17.8143 -6287 4 46.9755 31.6479 27.4044 17.0933 -18.1054 -4.43643 -6288 6 27.7087 1.63781 7.50008 21.5285 -7.57238 -25.6841 -6289 4 26.9556 1.59549 8.05597 -25.0455 5.22958 17.9803 -6290 4 27.5166 0.963037 6.82134 -2.90509 7.89899 -0.0646572 -6291 6 54.8922 20.8 16.0331 4.1789 -41.4982 -7.93337 -6292 4 54.9282 20.9554 16.9716 0.186425 8.83729 15.9831 -6293 4 0.211633 19.8495 15.948 -9.91253 29.0383 -5.43741 -6294 6 37.4291 33.0056 34.4398 -14.0977 10.8622 -7.94924 -6295 4 37.2978 32.0826 34.6133 -1.58878 -21.6351 7.1631 -6296 4 36.5764 33.2755 34.0173 17.7258 4.45123 10.3439 -6297 6 19.5104 39.7742 6.7506 5.90241 -38.4201 -4.61078 -6298 4 19.1293 39.2182 6.01225 10.8403 19.9531 16.5545 -6299 4 19.9162 39.0938 7.35425 -12.9804 24.3225 -11.3083 -6300 6 32.4399 2.72699 8.06906 17.0773 23.4006 1.78158 -6301 4 32.9347 3.14941 8.81642 -19.9733 -16.2934 -9.37408 -6302 4 31.5531 2.49842 8.37658 0.516726 -6.41942 5.39598 -6303 6 12.9757 16.0915 4.06618 3.48233 -26.1302 -11.2272 -6304 4 12.5744 15.6527 4.83433 -0.695682 4.00385 -3.98901 -6305 4 13.3513 15.3473 3.55621 -4.30287 11.2057 5.6128 -6306 6 4.64677 29.9233 5.42983 -10.8182 14.2385 -56.8973 -6307 4 4.99957 30.1958 4.52107 -6.90737 -7.02982 36.161 -6308 4 3.86081 29.3683 5.18005 29.0195 11.7205 17.0104 -6309 6 29.7541 32.1122 24.0662 13.5325 13.0696 7.67536 -6310 4 30.657 32.2311 24.4313 -14.6232 -5.62961 -5.85099 -6311 4 29.8358 31.5529 23.3009 -2.99915 -14.1964 -7.88188 -6312 6 11.8689 30.6971 33.4711 -8.01032 -39.2081 28.7873 -6313 4 11.8961 29.8478 34.0479 -0.904256 41.1124 -29.4381 -6314 4 12.7288 30.7703 33.0546 6.62137 -3.78113 1.33903 -6315 6 17.3676 40.4123 27.3051 45.9752 30.8726 -27.1152 -6316 4 17.3095 41.3718 27.4557 -2.78012 -6.90788 -0.219066 -6317 4 16.6513 39.9873 27.6906 -54.0346 -15.2197 27.4879 -6318 6 8.66734 4.89901 8.93063 6.14116 -5.58058 -4.6479 -6319 4 8.35347 5.40804 8.18272 -1.2331 1.82325 -6.13974 -6320 4 8.16334 5.22925 9.67691 0.199365 1.34734 7.84993 -6321 6 39.5604 17.6833 9.57201 22.5105 -50.1639 -23.667 -6322 4 39.2658 17.6048 10.464 -10.5204 8.51393 23.2154 -6323 4 39.725 16.7168 9.31019 -10.6666 45.7312 -1.86495 -6324 6 31.4955 30.1755 28.5516 10.628 -19.507 17.1882 -6325 4 32.3525 30.3948 28.1778 -6.71462 8.32315 -8.11857 -6326 4 31.74 29.3729 29.0438 -14.9082 5.37925 -0.357203 -6327 6 52.6685 19.2672 40.0663 9.25056 16.4026 -20.0757 -6328 4 53.0106 18.7322 39.321 -9.61724 -4.6138 17.4516 -6329 4 53.0677 20.1385 39.8955 -5.74465 0.792691 -1.74468 -6330 6 3.24164 7.81666 9.85998 28.0429 9.66948 1.15728 -6331 4 3.83019 8.53432 10.2304 -23.9275 -17.8293 -12.7584 -6332 4 3.84853 7.29279 9.3074 -9.38214 5.4782 3.90821 -6333 6 23.129 35.218 35.5945 -25.4929 1.01472 15.9258 -6334 4 23.7784 35.3391 34.9359 33.2897 3.00284 -24.4901 -6335 4 22.5015 35.9398 35.4197 -4.85807 -5.03855 8.29984 -6336 6 19.51 14.0653 20.8221 -35.7596 -3.44758 -1.61502 -6337 4 19.8587 14.4985 21.6011 13.4146 6.44294 7.16022 -6338 4 18.5274 14.0852 20.9637 18.4505 -1.93413 -5.69736 -6339 6 23.6205 15.8624 24.0207 6.44012 -27.6666 -1.73497 -6340 4 23.7023 16.8084 24.0387 5.71305 22.1977 -2.17526 -6341 4 24.4604 15.4749 23.6823 -15.4387 15.2983 3.34328 -6342 6 0.280487 30.496 6.10097 2.10248 14.5258 38.6463 -6343 4 54.969 30.1752 5.28655 -5.78718 -18.1599 -43.8305 -6344 4 54.4568 30.8162 6.51538 2.11893 2.60892 6.09244 -6345 6 4.88818 13.213 29.1211 -10.1066 -44.834 -24.7823 -6346 4 4.81121 13.8494 29.7943 -5.77674 34.7781 35.8081 -6347 4 5.65875 13.4519 28.6173 14.302 5.76116 -10.624 -6348 6 54.2113 27.2762 19.1921 -15.5686 -30.3542 31.9917 -6349 4 0.068746 27.3681 19.6083 11.8738 0.793184 4.88761 -6350 4 54.2438 27.8077 18.4285 0.565084 22.1088 -37.313 -6351 6 13.9147 35.7477 9.19539 -9.45761 -42.0549 -30.4782 -6352 4 13.6498 35.0288 8.53341 12.0253 23.1831 27.3793 -6353 4 13.9217 36.5134 8.63033 3.91359 16.7787 -6.83247 -6354 6 5.91895 31.9062 18.8199 -10.5522 26.6577 -12.1166 -6355 4 5.59368 32.8276 18.7738 -3.70357 -9.82177 15.0022 -6356 4 6.3357 31.8271 17.9661 5.53766 -12.0386 -9.76018 -6357 6 5.80079 28.8629 9.48582 -4.23387 2.66619 -7.91216 -6358 4 5.1492 29.3316 10.0156 -4.194 3.81529 3.65919 -6359 4 5.26808 28.2356 8.96551 5.75879 5.11243 0.385299 -6360 6 40.1186 6.06288 9.7252 27.6823 -14.9678 -34.8134 -6361 4 40.0604 6.61837 8.91786 -4.97866 -6.72317 19.9534 -6362 4 40.8451 5.41953 9.46609 -26.5422 19.2978 14.9684 -6363 6 20.3249 13.4665 41.4109 48.5393 0.491453 -34.6424 -6364 4 21.248 13.7047 41.7262 -35.6043 -9.97545 -2.58991 -6365 4 20.4078 13.625 40.4256 -17.6073 -2.89865 23.6593 -6366 6 14.4355 21.7431 27.3521 26.8888 -5.93952 12.1752 -6367 4 15.3929 21.7238 27.5426 -15.4302 4.65814 3.66232 -6368 4 14.4086 21.5632 26.4128 -6.38145 3.02673 -3.91912 -6369 6 38.7552 1.80385 30.0529 11.0268 -28.3612 -27.359 -6370 4 38.4475 1.96331 30.9218 -11.1335 10.8767 32.3314 -6371 4 38.864 2.66369 29.6567 5.01485 14.1269 -3.82072 -6372 6 5.6038 10.8537 14.1812 -8.02182 -19.6512 10.0037 -6373 4 4.967 11.5707 14.1035 -3.71772 1.30399 -2.93081 -6374 4 5.11243 10.0991 14.6 11.6474 17.9462 -13.8385 -6375 6 45.4185 36.7135 27.9228 -18.8199 18.417 -42.2307 -6376 4 46.0687 36.7087 28.6222 8.21134 6.27257 3.16342 -6377 4 45.7172 37.2784 27.1471 -3.80026 -24.227 32.4306 -6378 6 54.0799 35.0377 20.3974 -0.144446 0.236923 -11.8112 -6379 4 53.8476 34.1116 20.536 0.519878 -4.41527 -2.37245 -6380 4 53.9532 35.2077 19.4441 0.866973 -0.817495 13.7238 -6381 6 42.0671 14.221 28.4749 -2.16655 -3.30611 3.54679 -6382 4 41.9442 13.9043 29.3971 9.00113 8.16851 -11.079 -6383 4 42.9986 14.4434 28.31 -2.56617 -4.72525 9.98454 -6384 6 34.845 7.68802 26.7053 1.50556 20.2543 7.34306 -6385 4 35.7046 7.39142 27.0344 -1.60005 -9.47728 3.59716 -6386 4 34.4934 7.05976 26.0702 4.4346 -10.8207 -3.70702 -6387 6 49.6605 30.7141 23.8514 -28.5275 -6.56067 -11.9374 -6388 4 50.4604 31.1934 23.8565 34.1351 17.5516 -0.640456 -6389 4 49.8146 29.9659 24.4072 5.37992 -19.8924 15.651 -6390 6 50.8948 7.80148 14.1671 21.5777 -12.9452 34.2787 -6391 4 50.8247 6.96775 13.7105 -4.99079 -12.0182 -18.7136 -6392 4 50.5655 8.51894 13.6572 -15.7049 17.9748 -24.3233 -6393 6 4.26893 39.4826 27.8512 8.9926 -8.51629 -1.47833 -6394 4 3.65831 40.2241 27.8513 -3.04259 7.34368 5.94949 -6395 4 4.00328 38.958 27.1013 -12.9816 -10.5728 -11.1653 -6396 6 8.75177 32.8341 8.22283 -21.5639 -30.1985 -34.1316 -6397 4 8.2383 32.1284 7.72694 10.6374 17.547 21.6449 -6398 4 8.83279 33.5372 7.56693 3.76401 9.53239 7.06969 -6399 6 52.9594 25.4882 9.38297 -25.0802 50.1357 20.0056 -6400 4 51.9882 25.4292 9.65119 35.7509 1.27265 -17.7678 -6401 4 53.158 26.4759 9.49827 -6.53976 -44.9947 -5.62964 -6402 6 29.5661 36.7256 19.4603 5.44621 -17.3757 32.4066 -6403 4 29.5786 37.3961 18.7906 9.88328 7.74732 -15.4263 -6404 4 30.4565 36.6309 19.8726 -14.3545 4.38723 -10.5986 -6405 6 52.3236 36.1013 25.1169 17.8415 -25.8683 -35.0149 -6406 4 52.9656 35.7372 25.71 20.0999 5.67458 7.00157 -6407 4 51.6595 36.4261 25.6714 -35.904 19.3861 23.0835 -6408 6 21.182 15.7103 31.1872 -18.8583 3.19523 -20.0756 -6409 4 20.6533 16.2005 30.5215 19.2403 -4.60119 13.454 -6410 4 20.518 15.2243 31.6931 2.46505 1.20146 2.10658 -6411 6 10.6569 22.4337 39.4531 2.51655 -26.4213 -37.4968 -6412 4 10.8327 22.4219 38.4645 -4.29248 9.16844 28.2769 -6413 4 10.2506 21.5589 39.6181 7.08653 12.2011 0.686531 -6414 6 25.1113 11.6729 22.7164 -12.9971 -0.576423 -18.0399 -6415 4 25.1382 11.4787 23.6279 21.2779 0.00518046 39.517 -6416 4 24.1824 11.5118 22.5586 2.84555 -0.272219 -17.8246 -6417 6 31.7896 10.4703 2.90217 -23.2712 -10.1944 -9.79051 -6418 4 32.6146 10.7499 3.28348 13.8778 6.97942 -8.99307 -6419 4 31.8394 10.4464 1.92418 10.0551 5.29594 18.2662 -6420 6 52.4849 36.4361 22.1663 -9.62786 -33.6069 5.21212 -6421 4 53.146 36.0606 21.5474 -12.5852 0.946736 4.3316 -6422 4 52.0694 35.6392 22.6209 17.7505 30.3514 -16.202 -6423 6 46.2093 40.0329 26.9877 0.0297183 29.9961 33.6049 -6424 4 46.4751 39.2742 26.5126 9.55695 -26.8643 -22.4205 -6425 4 45.9048 40.7092 26.3771 -3.76152 -2.91476 -3.34389 -6426 6 24.0885 36.7218 39.1011 7.12362 -3.16907 -4.80429 -6427 4 23.5999 35.9078 38.9667 11.8985 -11.6148 -5.9332 -6428 4 23.4559 37.2234 39.5891 -11.7402 16.6095 17.3029 -6429 6 22.3514 7.42547 31.8169 -35.2707 -41.8068 15.3628 -6430 4 22.2213 8.33277 32.0647 5.94025 21.3422 4.40196 -6431 4 21.6465 6.92073 32.3398 32.1745 21.6054 -24.7594 -6432 6 14.3502 18.3597 4.09728 -2.0055 -9.38358 23.348 -6433 4 14.1099 17.4219 3.93107 -0.92654 19.6042 10.3569 -6434 4 14.0726 18.5364 5.03654 13.0175 -10.3464 -23.9346 -6435 6 27.3175 38.46 0.124188 33.1007 -9.911 1.68747 -6436 4 26.9395 39.2806 0.463932 -4.88512 2.40457 5.81864 -6437 4 28.2608 38.413 0.45438 -35.2324 2.96259 -2.16122 -6438 6 18.6695 0.162292 12.2239 -43.166 1.81748 26.3235 -6439 4 17.7303 0.262878 12.5713 26.4571 2.30278 -22.2908 -6440 4 18.9433 41.3202 12.7499 8.63834 -11.46 6.42912 -6441 6 49.423 24.9792 25.3382 20.605 1.42964 -0.346179 -6442 4 48.5484 24.7002 25.6009 -12.613 -0.556076 -3.92373 -6443 4 49.3508 25.8032 24.8352 -9.8769 -5.62219 -3.2466 -6444 6 52.0685 20.2858 15.7446 -45.9435 -8.75518 14.7384 -6445 4 52.9731 20.5149 15.783 39.268 6.79994 2.42829 -6446 4 51.7449 20.2597 16.6676 4.81444 3.79951 -9.92674 -6447 6 49.6576 15.6472 38.4942 19.425 -17.6129 -0.00729052 -6448 4 49.2099 16.0165 37.7231 -6.98596 1.36616 -1.50856 -6449 4 49.5102 16.1958 39.2633 -14.7214 13.7889 5.58845 -6450 6 15.9211 23.7235 13.4193 23.3289 -36.8815 11.3263 -6451 4 16.506 23.7025 14.2147 -19.633 8.70021 -19.3267 -6452 4 15.5217 24.5725 13.2813 -7.62789 19.6624 11.7876 -6453 6 14.3566 29.1635 14.3074 -12.0826 22.9902 -11.8551 -6454 4 14.1263 29.6193 13.4563 6.10678 -19.1115 21.2229 -6455 4 14.1254 29.8374 14.9735 4.9154 -5.66101 -4.10969 -6456 6 30.4264 19.8612 16.8883 21.8822 -42.1222 -1.02119 -6457 4 30.7186 19.5182 17.7453 7.89699 4.38367 -1.56912 -6458 4 29.8579 20.5689 17.0557 -25.7709 36.069 4.20145 -6459 6 21.3137 21.0352 23.1207 17.1515 -0.95565 24.203 -6460 4 22.2175 21.149 23.495 -16.5785 2.35003 -9.75668 -6461 4 20.7278 21.0809 23.8918 1.9436 3.71589 -4.02445 -6462 6 32.3543 0.425745 25.2542 2.91189 -3.53517 -15.1456 -6463 4 32.2281 0.339162 24.2978 10.7775 -1.18886 4.59452 -6464 4 31.5305 0.792307 25.5362 -21.0885 6.89421 14.2132 -6465 6 26.144 32.4145 27.5224 1.5207 15.2147 0.716215 -6466 4 25.5792 33.1636 27.3089 1.00017 8.92672 2.49827 -6467 4 25.8737 31.7446 26.908 1.40169 -15.6227 -12.5261 -6468 6 31.6924 23.0038 41.4488 2.9891 4.25247 18.5975 -6469 4 32.5817 22.7219 41.7427 -10.6129 2.19465 -7.80737 -6470 4 31.0787 22.7203 0.234806 2.54762 2.31931 -6.22567 -6471 6 54.3675 17.8383 10.7129 6.79577 23.0573 52.4548 -6472 4 53.55 18.2477 10.4428 -14.1319 6.62767 -11.4304 -6473 4 54.6119 17.1874 10.0964 4.54612 -26.2874 -33.1105 -6474 6 15.4111 28.5567 8.624 -23.5209 17.7221 -14.2225 -6475 4 14.7074 29.0083 8.07604 23.4242 -18.2482 9.63627 -6476 4 15.9053 27.9212 8.07642 -10.4486 8.35345 -4.07335 -6477 6 21.923 22.3267 27.6697 4.39763 -15.072 3.90508 -6478 4 22.0757 23.261 27.7591 9.36727 14.8743 -6.39222 -6479 4 22.0153 22.013 28.5729 -4.02641 -8.91923 4.38679 -6480 6 2.936 17.0367 8.13301 26.8737 -0.816539 -9.93732 -6481 4 3.80704 17.1417 7.69888 -17.5309 -13.2134 -6.39661 -6482 4 2.90872 17.8246 8.6543 -8.08771 15.2208 15.3377 -6483 6 27.578 18.2783 3.98106 42.3665 -21.0645 -7.59535 -6484 4 26.9838 18.9866 3.87461 -35.9411 25.5305 -3.32845 -6485 4 28.3853 18.6252 3.56495 -11.0807 -10.9366 8.58166 -6486 6 24.7671 24.5333 8.4671 -3.55267 7.94183 -11.8318 -6487 4 25.0347 23.6359 8.24775 3.17664 -3.45343 1.13667 -6488 4 24.5725 24.5372 9.40731 3.34714 4.39373 0.466573 -6489 6 41.9868 30.4684 13.7801 28.6364 -21.7839 2.09937 -6490 4 42.9472 30.4515 13.6527 -5.43777 20.4489 -0.76134 -6491 4 41.8419 29.5153 13.705 -23.7897 6.87836 6.63004 -6492 6 15.6883 34.6775 41.5701 28.3539 0.757195 5.77675 -6493 4 16.4499 35.2822 41.5481 -1.40988 -1.74654 9.10263 -6494 4 14.9914 35.2483 41.869 -21.9895 7.57474 1.73196 -6495 6 11.1473 19.7636 40.5906 -7.01786 -3.24743 -12.0486 -6496 4 12.0915 19.8265 40.3679 -7.75233 -10.0339 3.8807 -6497 4 10.7912 18.9088 40.243 10.6872 10.1147 9.9033 -6498 6 47.4955 34.5311 14.2936 14.7321 -31.661 -1.66099 -6499 4 46.9342 35.3117 14.2317 -6.87541 2.2103 -19.2779 -6500 4 47.4978 33.9137 13.4978 -3.14061 27.4792 16.9676 -6501 6 12.3981 26.9866 28.4861 26.5251 -74.1409 -7.08463 -6502 4 13.226 26.8461 29.0045 -10.1246 11.0422 -0.548558 -6503 4 12.3843 26.0988 27.9797 -6.45597 45.1087 15.272 -6504 6 27.6352 16.207 39.8297 -11.2321 14.8168 6.13397 -6505 4 27.2166 15.4175 40.1567 -13.0977 -6.13948 14.8525 -6506 4 28.2209 15.8539 39.184 23.7477 -3.37658 -20.6816 -6507 6 33.4012 31.2187 27.2758 -9.34358 5.5086 -22.6345 -6508 4 34.125 31.7676 27.5967 0.31405 7.14405 -9.79506 -6509 4 32.8978 31.7031 26.5666 21.3968 -7.09575 17.214 -6510 6 39.0983 39.5786 31.9234 0.802497 -2.15341 -0.194752 -6511 4 38.8245 39.6381 30.9898 -0.836727 0.773065 10.2743 -6512 4 38.5517 40.2102 32.4207 8.13236 -5.11153 -2.10971 -6513 6 22.8875 16.5662 19.9556 -18.6429 -47.4181 0.677292 -6514 4 23.2714 15.7467 20.3471 4.73069 19.3315 1.98369 -6515 4 22.0725 16.1814 19.5628 10.6014 14.9969 -2.71875 -6516 6 23.9725 21.8734 10.5896 -27.2099 14.1239 -19.8382 -6517 4 22.9807 21.8764 10.5048 23.1264 -0.860286 11.7265 -6518 4 24.1883 21.166 11.1844 -1.51334 -13.3572 20.4185 -6519 6 40.1791 25.4384 2.79385 3.27033 10.4385 -27.7191 -6520 4 40.1215 24.9503 3.60378 -1.57927 -2.0951 21.761 -6521 4 39.8421 26.3422 2.89187 -4.34677 -6.39915 11.9951 -6522 6 15.0222 19.7637 9.4145 -47.1416 28.5942 15.5409 -6523 4 14.7277 20.7258 9.2944 13.9352 -33.0223 -5.4956 -6524 4 14.1981 19.3167 9.80349 37.3596 11.4933 -12.2096 -6525 6 7.16734 24.8761 0.122492 -38.9593 -14.3052 4.78001 -6526 4 7.92262 24.7355 41.4818 28.9246 2.82935 -8.29154 -6527 4 7.37325 25.3267 0.937782 12.1222 2.94845 5.10402 -6528 6 43.395 10.8961 31.3295 35.6095 27.14 14.9602 -6529 4 43.8689 11.0333 30.4778 -14.9331 -12.4968 13.4948 -6530 4 44.125 11.0026 32.0067 -24.5429 -5.74221 -22.764 -6531 6 13.8447 19.0699 27.8622 -3.35019 15.2359 -6.83255 -6532 4 12.9833 18.7163 28.0985 -4.55464 1.4506 5.93475 -6533 4 13.7874 20.0538 27.8435 3.60016 -14.5834 0.921784 -6534 6 3.48728 19.5892 9.61273 -55.7314 7.48447 -10.4955 -6535 4 2.69835 20.0905 9.96963 22.9021 -19.0673 -4.76373 -6536 4 4.2501 19.9102 10.0538 23.4289 5.03115 15.3445 -6537 6 51.0169 19.4212 7.7195 26.3048 39.1054 -53.7154 -6538 4 50.748 20.2575 7.21364 -2.7273 -32.3506 28.7892 -6539 4 51.8579 19.2204 7.21263 -29.2082 -7.0208 18.9647 -6540 6 42.2149 2.6091 10.4112 25.8935 -20.0624 -18.8025 -6541 4 43.1623 2.45904 10.6444 -24.152 11.2038 4.82319 -6542 4 42.1853 2.33112 9.4647 -3.80011 10.6068 21.7004 -6543 6 30.7928 6.43901 35.1986 -21.6247 -20.8821 1.11778 -6544 4 29.8295 6.39304 35.3716 10.0359 5.79706 -2.44011 -6545 4 31.0478 5.50645 35.0814 0.649811 9.90023 -1.69835 -6546 6 52.8722 36.96 18.5947 9.01539 9.27494 -7.55423 -6547 4 52.0657 36.4448 18.5061 -12.9065 3.13675 2.3407 -6548 4 52.6935 37.8522 18.2226 2.03776 -15.609 7.12003 -6549 6 44.2018 6.29599 1.04883 9.29405 17.1768 7.51252 -6550 4 44.5044 7.06671 1.58929 -4.49779 -17.4812 -0.431191 -6551 4 44.952 6.10526 0.487985 -0.115844 -2.61588 -3.46335 -6552 6 42.1326 38.6047 31.1849 18.5327 -13.3283 33.8135 -6553 4 41.7834 38.9864 30.4106 -14.9936 10.8543 -35.8121 -6554 4 41.4904 38.8324 31.8627 -0.641051 1.33351 1.93 -6555 6 43.7219 12.8013 9.05519 -6.282 7.91343 -40.7352 -6556 4 43.3171 13.69 8.87718 10.3632 -22.6116 8.3507 -6557 4 43.9578 12.415 8.15014 1.61383 14.3586 37.3488 -6558 6 13.4062 0.438838 6.51561 -30.6084 29.4042 -0.600484 -6559 4 12.9719 1.14899 7.05573 20.0807 -17.3818 -8.1595 -6560 4 13.3782 0.782754 5.59696 2.59294 -3.03922 8.63079 -6561 6 16.1217 13.2907 10.2805 -3.10591 -25.3511 -12.454 -6562 4 16.8946 12.7568 10.5076 8.02861 4.25978 2.86397 -6563 4 15.5299 12.6092 9.88546 -0.135156 17.9383 7.81515 -6564 6 1.59113 8.48217 4.69745 0.410151 -22.2633 16.3582 -6565 4 1.97054 9.1194 4.11301 8.92831 16.113 -22.7699 -6566 4 2.26765 8.43533 5.38895 -6.97239 3.0759 6.50405 -6567 6 37.2935 1.72102 10.5172 -13.7439 -9.21578 15.0824 -6568 4 37.1042 2.64553 10.595 10.0955 20.4226 -13.0857 -6569 4 36.8105 1.41855 11.2983 8.13599 -13.5394 -0.658926 -6570 6 53.8411 9.88961 17.6933 -45.7386 -38.9159 3.57486 -6571 4 54.5353 10.0399 17.0846 27.4782 6.59889 -23.5339 -6572 4 53.3721 9.08338 17.329 10.482 22.3983 14.0606 -6573 6 45.4787 30.6173 15.8038 -24.3966 -4.27047 13.1326 -6574 4 44.7717 31.1876 16.1963 22.3351 -9.42651 -10.1125 -6575 4 45.1907 29.6979 15.9324 6.84487 10.052 -2.21901 -6576 6 39.9241 16.6394 33.8426 -26.8877 -6.37158 -14.218 -6577 4 39.1549 17.2016 33.5476 23.291 -18.1751 3.42158 -6578 4 39.818 15.753 33.3934 2.94846 26.4583 15.0268 -6579 6 32.8532 24.7638 27.9368 9.55773 21.8346 -14.3088 -6580 4 33.6229 25.0593 28.4772 -14.6217 4.84572 -15.4057 -6581 4 32.6055 25.4822 27.2751 14.9958 -18.2832 35.5187 -6582 6 7.86628 31.6164 24.1091 22.2934 14.9204 62.1634 -6583 4 7.77595 30.8628 24.7489 -5.82572 16.0022 -25.8365 -6584 4 8.17309 32.3545 24.746 -24.9312 -26.1857 -42.8493 -6585 6 43.5324 41.3356 15.8165 16.5067 -5.02973 0.188395 -6586 4 43.1944 0.320073 15.7896 -5.69638 5.43212 -4.38793 -6587 4 44.429 41.3992 15.443 -10.6291 -2.88383 0.315207 -6588 6 20.021 29.5505 33.1902 25.0419 -7.98688 14.3875 -6589 4 20.8911 29.4069 33.5992 2.6372 -12.3274 -8.42754 -6590 4 19.6576 30.1636 33.8147 -14.9588 14.7065 -0.197692 -6591 6 43.4056 21.4569 18.6265 10.2156 -2.1017 15.5441 -6592 4 43.0498 21.3696 19.5313 -0.699705 -7.60676 -10.3888 -6593 4 42.9844 20.831 18.0298 -12.2248 -1.50447 0.773582 -6594 6 3.43117 19.1215 18.408 34.3393 4.70286 11.768 -6595 4 3.22621 20.0564 18.4267 -2.18643 4.81974 -5.59269 -6596 4 2.60088 18.6799 18.3703 -20.3233 -14.3491 -1.28903 -6597 6 41.6742 38.1112 16.3299 0.384784 -42.0766 -46.2559 -6598 4 41.8939 37.3404 15.6708 -9.75075 44.1094 34.3099 -6599 4 42.3403 38.1083 17.0131 5.25517 -2.87066 6.28124 -6600 6 7.56339 36.3915 10.5048 -18.8567 -13.4705 -13.5944 -6601 4 6.70677 36.1596 10.0967 9.18231 15.0261 0.193132 -6602 4 7.92251 35.493 10.5558 6.04756 10.3771 12.1048 -6603 6 36.2642 19.1103 34.8187 -40.4108 -29.7457 -43.4097 -6604 4 35.4719 19.3187 34.2477 20.3247 -4.92751 27.2967 -6605 4 36.4213 19.8813 35.3193 7.80254 33.8099 20.7293 -6606 6 53.576 24.9483 12.6399 1.20561 -0.517111 -17.326 -6607 4 53.6619 25.9414 12.669 8.79141 -29.2645 -7.24265 -6608 4 53.913 24.5623 11.7782 -4.09912 18.2899 28.1509 -6609 6 31.6824 10.4618 21.0892 -21.9557 -25.3726 -8.81809 -6610 4 31.4281 9.67391 21.5915 5.84781 10.5911 6.7189 -6611 4 30.8909 10.5838 20.5303 11.506 8.60894 0.332243 -6612 6 18.1093 28.7861 17.1823 13.2379 18.2354 -13.1758 -6613 4 19.074 28.7105 16.9739 -24.5165 5.38082 5.29014 -6614 4 17.7652 29.607 16.728 11.5472 -26.6353 13.0333 -6615 6 21.6834 18.2239 36.88 17.2587 0.811675 -5.67627 -6616 4 22.5671 18.027 36.4721 -27.7349 -1.55215 19.1593 -6617 4 21.6367 17.7543 37.7464 -1.70499 5.95625 -12.509 -6618 6 25.0551 19.0348 34.2287 -62.1041 -5.07763 23.2016 -6619 4 24.7663 18.3443 34.8719 5.43786 16.9757 -10.9409 -6620 4 25.8827 18.7578 33.9618 64.2031 -27.8273 -22.1538 -6621 6 15.5709 13.019 5.5539 0.00735057 -17.6807 20.5563 -6622 4 15.9927 13.3293 6.36292 0.0692085 12.4919 -5.39058 -6623 4 15.4491 12.0681 5.73828 -2.05735 13.2604 -17.7033 -6624 6 54.47 41.6402 14.7959 12.609 -13.6787 23.2741 -6625 4 54.8097 41.4531 15.6947 -1.45983 11.4249 -10.5768 -6626 4 53.7709 40.9948 14.7271 -15.6812 0.146288 -8.92901 -6627 6 1.6639 26.4809 31.3827 12.672 -25.15 69.1319 -6628 4 2.55491 26.3764 31.7735 -12.447 -0.333387 -5.00094 -6629 4 1.81595 26.6127 30.4938 10.6163 16.8649 -70.5286 -6630 6 32.3417 37.2868 29.6843 -28.8191 13.9029 5.49332 -6631 4 31.5776 37.8992 29.8843 22.0104 -18.6347 -4.04342 -6632 4 33.1171 37.6855 30.0945 4.79121 1.59444 1.77014 -6633 6 52.7104 21.0422 22.8867 -25.9211 15.4876 17.6965 -6634 4 51.8895 21.5407 22.5959 27.9099 -16.7396 2.24416 -6635 4 53.1785 20.6742 22.1421 1.33026 -7.16251 -14.9349 -6636 6 32.7465 28.5808 40.5193 19.5614 -2.95666 4.13778 -6637 4 32.1272 29.2507 40.2236 -19.1805 -2.02865 5.11045 -6638 4 32.5793 28.3106 41.4408 -7.78706 5.87783 -13.0149 -6639 6 23.6078 32.0654 16.3528 6.52471 10.7856 29.7964 -6640 4 24.3701 32.0729 16.9793 -11.8963 -10.2614 -20.8491 -6641 4 22.8856 32.382 16.9256 -1.99185 -7.37994 -15.8659 -6642 6 37.5296 9.17182 29.9714 -32.9897 5.30306 10.5453 -6643 4 36.7716 8.86544 30.5111 15.5785 -5.70066 -5.7121 -6644 4 37.1221 9.9689 29.5744 15.1662 -5.45151 -1.53858 -6645 6 2.26386 24.3835 14.5546 6.71022 -7.72281 -24.2479 -6646 4 1.85963 24.0133 15.3587 -6.19133 3.33276 -9.20692 -6647 4 2.05254 23.8227 13.7642 -0.610841 12.6744 29.5344 -6648 6 27.3686 28.7935 24.7702 8.50672 -13.2399 -34.495 -6649 4 27.2338 28.4442 25.6457 -6.20833 -8.14759 12.6395 -6650 4 27.3624 28.0447 24.1031 3.25167 21.2409 25.246 -6651 6 16.785 2.54959 14.3094 -6.20571 44.0359 18.8502 -6652 4 17.7332 2.53792 14.3228 12.8455 -14.2273 -3.64568 -6653 4 16.4133 1.8101 13.8617 -1.35631 -25.1723 -17.3636 -6654 6 21.8048 39.8028 36.8143 34.4281 41.1875 6.43987 -6655 4 22.7768 39.6281 36.9504 -24.2083 -5.20947 -5.56999 -6656 4 21.4132 39.0119 36.5213 -11.0202 -42.2818 -12.3994 -6657 6 14.0639 6.48367 41.5586 -1.33856 -25.5903 -39.7582 -6658 4 14.9412 6.10051 41.3922 2.86672 3.38346 15.7648 -6659 4 14.0719 7.05039 0.399753 4.3465 12.2327 22.8772 -6660 6 14.5548 16.5075 9.32956 22.0841 -14.7784 -21.2506 -6661 4 15.3586 16.5914 9.87503 -6.36199 2.72911 -6.08794 -6662 4 13.8899 17.0883 9.65711 -8.71884 14.1475 23.1102 -6663 6 8.67066 23.4815 30.5556 -44.0195 -7.59097 13.7496 -6664 4 9.49671 23.6557 30.1334 33.8338 1.75787 0.0184994 -6665 4 8.69311 23.4014 31.5307 16.0679 1.7618 -7.5699 -6666 6 37.6567 2.07706 19.9993 -10.7882 4.4912 14.9507 -6667 4 36.977 2.26584 19.3592 -1.31755 -8.36894 -24.369 -6668 4 37.311 2.65872 20.6865 17.7477 -2.01295 10.0374 -6669 6 42.7201 7.55732 8.02256 37.7013 -31.8103 68.6738 -6670 4 43.2078 7.90139 7.31041 13.9641 18.3531 -33.1003 -6671 4 43.4713 7.36984 8.74143 -54.3005 13.1784 -34.8973 -6672 6 38.5678 29.6657 6.85728 10.4727 -7.97498 12.0381 -6673 4 38.5138 29.2192 7.70857 5.95943 6.40388 2.63109 -6674 4 37.7242 29.471 6.47402 -15.8477 4.38345 -15.5494 -6675 6 42.5297 15.7017 39.7864 -1.2311 2.72873 2.24862 -6676 4 42.7877 16.6334 39.6476 -7.55712 -4.9727 -7.52807 -6677 4 42.0746 15.3358 38.9963 17.4435 12.5166 7.69263 -6678 6 19.8571 7.43592 22.0545 -24.1472 -5.51637 33.4113 -6679 4 19.2244 8.12179 21.7601 9.35088 -5.78158 -2.10146 -6680 4 19.4596 7.11536 22.9248 14.2781 17.6372 -34.9907 -6681 6 27.4149 3.22069 12.5516 40.9266 14.4549 -35.8463 -6682 4 28.3021 3.29229 12.0821 -30.0356 5.19144 18.8294 -6683 4 27.3767 2.28812 12.7581 -5.67627 -4.82192 6.74426 -6684 6 34.4116 6.50186 34.3661 -21.9879 -4.07114 7.78674 -6685 4 33.6675 7.13398 34.4265 8.52018 -4.33452 -1.60522 -6686 4 34.0848 5.70903 34.842 8.55338 12.1797 -0.556276 -6687 6 9.89342 27.9558 39.7643 36.6491 -8.46867 13.0669 -6688 4 10.8456 28.0225 40.104 -41.9626 -4.51635 -15.7261 -6689 4 9.67004 28.8098 39.3873 2.34979 10.3628 -2.65954 -6690 6 50.5619 22.115 6.39208 17.1303 26.4748 31.0688 -6691 4 51.4904 22.4109 6.45725 -8.74694 -11.3909 -7.00891 -6692 4 50.1939 22.6078 7.15954 -8.62199 -11.7106 -16.757 -6693 6 47.1151 11.4881 30.0373 19.0993 -20.4412 31.5796 -6694 4 47.2481 10.8506 30.7795 8.25865 21.4973 -13.9376 -6695 4 46.3269 11.1564 29.6474 -26.9131 -5.13028 -17.9745 -6696 6 25.9416 28.4741 9.79918 -11.6773 -32.55 32.2578 -6697 4 26.8348 28.2861 10.1548 -13.4597 2.20587 -7.83095 -6698 4 25.3328 27.8368 10.2912 20.3964 27.2145 -12.4741 -6699 6 35.4384 36.5941 19.4416 12.9267 19.1414 22.694 -6700 4 35.4164 36.6623 20.432 -0.885856 -8.21646 -20.3497 -6701 4 36.1159 37.2681 19.2232 -9.51806 -6.29836 -4.59986 -6702 6 39.0948 17.8654 12.2958 16.402 12.2899 -6.89152 -6703 4 39.0474 18.8007 12.5965 -2.38328 -10.6878 -1.40665 -6704 4 38.4419 17.3626 12.7715 -16.1853 0.319976 14.0097 -6705 6 2.67108 27.1436 2.40101 -1.75759 -3.65761 -8.1759 -6706 4 1.9876 27.5644 1.84788 8.2175 -2.76418 4.2561 -6707 4 2.53155 27.392 3.3289 1.87867 -1.67129 -3.85288 -6708 6 12.3359 32.2055 21.5153 -21.7508 0.12991 31.168 -6709 4 12.6488 32.0797 22.4173 29.0853 13.2861 -13.6486 -6710 4 11.491 31.8094 21.7155 -17.148 -0.720271 -25.2422 -6711 6 32.8833 32.3716 8.45599 -19.6455 -21.472 -14.5807 -6712 4 33.4538 32.8256 9.05859 9.48117 21.6574 11.6239 -6713 4 31.9723 32.7028 8.50155 9.17651 3.82723 3.41156 -6714 6 12.6485 6.44458 31.9777 -6.29944 1.49663 15.4125 -6715 4 13.1578 6.35833 31.1835 12.9638 -3.65534 -14.9347 -6716 4 11.7474 6.25334 31.7296 -4.07419 -1.29291 -2.47195 -6717 6 41.3645 27.7433 14.0415 -6.01814 -18.8263 -25.007 -6718 4 41.8124 27.3175 13.2596 -11.5333 15.588 22.1217 -6719 4 40.3975 27.5756 13.9407 20.5065 3.01622 5.4742 -6720 6 6.60161 16.499 25.4489 9.93734 -1.87947 -15.8553 -6721 4 7.35848 15.8951 25.4583 3.3895 5.33583 -1.00098 -6722 4 6.02379 16.0419 24.8253 -6.53341 1.34025 8.2366 -6723 6 21.7786 39.2974 13.3607 -58.7317 27.2846 42.4257 -6724 4 22.3848 39.3902 12.6828 41.4687 -6.70168 -50.5194 -6725 4 21.6228 40.2371 13.624 5.27297 -27.3266 2.34771 -6726 6 34.8408 6.01319 6.94562 -18.4641 -1.51643 5.78804 -6727 4 33.8445 5.90926 6.91888 31.3517 2.57767 -4.40922 -6728 4 35.1545 6.28252 6.0657 -8.54142 -2.93715 0.97402 -6729 6 33.0232 30.4151 33.1713 -30.7469 -3.39927 -39.9685 -6730 4 32.1382 30.6983 32.7963 25.7009 -18.3352 9.36685 -6731 4 33.1108 30.988 33.8978 7.7837 23.494 30.6115 -6732 6 15.4491 32.4129 12.2013 37.3068 -21.1945 16.3611 -6733 4 16.3823 32.073 12.2446 -28.3662 8.39135 1.47263 -6734 4 15.4224 32.8258 11.3561 0.313824 15.5191 -23.5701 -6735 6 12.6648 26.6033 21.3782 33.3074 -46.6123 -64.9668 -6736 4 12.0344 25.8976 21.5501 -12.6652 14.4466 17.403 -6737 4 12.7392 27.3327 21.935 -15.9008 39.2731 46.5109 -6738 6 47.0171 36.3051 29.9756 -14.9097 -3.99946 59.7783 -6739 4 47.3887 37.0247 30.5306 -0.120183 -5.44251 -19.0377 -6740 4 46.4147 35.8463 30.6463 22.302 11.6315 -30.1098 -6741 6 0.299553 12.7005 23.3858 -50.0817 10.3486 20.6993 -6742 4 0.55843 11.8154 23.133 6.9712 -0.709946 -9.28769 -6743 4 54.2783 12.6185 23.429 39.7411 7.62342 -2.706 -6744 6 54.1651 18.9185 21.5773 -27.3575 7.2555 -32.8787 -6745 4 0.055729 18.801 21.8215 42.2187 -10.4087 33.76 -6746 4 54.2632 18.7361 20.6344 -21.3012 2.13243 0.141772 -6747 6 25.7162 24.2884 23.7449 23.2111 -33.139 -2.25213 -6748 4 25.1836 23.5617 23.2944 18.61 24.747 21.927 -6749 4 26.5708 23.8587 24.0884 -36.4232 14.4676 -16.0896 -6750 6 11.8952 29.0236 26.8796 9.31073 -5.31833 9.58593 -6751 4 12.582 29.6684 27.1204 -3.01706 -1.21814 -5.31042 -6752 4 12.0145 28.319 27.5465 -5.16863 11.8863 -12.5997 -6753 6 48.0052 35.8598 10.6996 -18.0426 -22.591 -32.4945 -6754 4 48.7896 35.6794 10.1443 -7.64403 10.0758 9.7343 -6755 4 48.2747 36.3464 11.4544 19.4818 11.8303 20.3364 -6756 6 47.6544 29.8545 36.9555 47.7155 -39.8456 -42.9298 -6757 4 48.1196 29.373 36.1789 -16.9409 17.9192 43.9777 -6758 4 46.9556 30.2951 36.4995 -17.6283 12.0501 3.0439 -6759 6 7.32865 12.3513 10.6225 -20.3459 13.1064 -14.334 -6760 4 7.20572 12.8267 9.76478 7.03806 -14.4953 16.449 -6761 4 6.49136 12.5857 11.0944 24.1086 -12.0498 -8.15528 -6762 6 52.9256 15.9641 4.89737 -18.3283 -2.7411 -11.4996 -6763 4 53.001 16.1105 3.94443 2.36662 -0.713792 8.85774 -6764 4 53.8018 16.0105 5.25645 21.1817 2.44507 8.14275 -6765 6 10.6731 16.9472 34.6118 -36.7423 -4.99845 -47.4494 -6766 4 11.0533 16.8484 35.4724 -5.12202 -12.2675 26.0308 -6767 4 9.83371 16.4151 34.3796 40.245 18.7583 25.5995 -6768 6 25.147 31.0596 36.0152 -5.60145 -19.7687 -32.0201 -6769 4 25.7935 31.7656 36.1171 1.22463 2.78419 -3.72446 -6770 4 25.3418 30.5949 35.1615 -4.38154 15.6016 24.1358 -6771 6 34.0913 21.8858 41.4775 -4.76405 18.1665 32.5634 -6772 4 33.6625 21.1007 41.1787 -2.29922 -28.5955 -6.85504 -6773 4 34.6054 22.1733 40.7506 14.2114 10.2598 -30.2937 -6774 6 15.7731 30.0818 1.26798 39.0641 -13.3599 -49.0464 -6775 4 15.0823 30.4241 1.791 -23.818 19.5269 30.6537 -6776 4 16.2108 30.862 0.84325 -15.3415 -19.24 18.755 -6777 6 29.5302 27.8609 16.6022 -41.3972 -29.0796 28.0786 -6778 4 29.3307 26.8764 16.753 17.6765 42.2449 -1.67193 -6779 4 28.8227 28.3009 17.156 20.6394 -5.21731 -15.3441 -6780 6 39.6438 9.77612 0.552706 9.07327 13.2864 29.0584 -6781 4 40.129 10.5839 0.897097 -15.1313 -20.9808 -12.8857 -6782 4 39.4906 9.23066 1.36029 2.34479 9.54176 -15.0004 -6783 6 1.51524 31.8825 16.4089 -15.0842 0.567558 32.708 -6784 4 2.11225 32.2249 15.7721 17.5465 17.6302 -23.3114 -6785 4 1.56386 30.9485 16.2687 -0.663138 -25.5376 -6.36093 -6786 6 8.73078 39.8635 25.0545 2.96185 -34.7465 -17.9129 -6787 4 8.00321 39.5602 25.6169 4.07363 9.59654 5.53067 -6788 4 8.89391 40.7829 25.2096 -1.06312 24.7623 5.36493 -6789 6 42.3301 10.2778 9.76455 0.0249942 22.0437 -8.66619 -6790 4 42.035 10.1947 10.6715 6.68889 -4.55788 7.04955 -6791 4 42.6957 11.1854 9.68656 -1.85544 -15.7885 0.75259 -6792 6 13.241 7.61416 1.95847 -11.6175 -6.73398 30.6404 -6793 4 13.9892 7.82191 2.54806 -1.36929 5.6022 -7.80568 -6794 4 12.5695 7.22502 2.56499 11.7798 7.16895 -16.7116 -6795 6 18.7434 40.0583 14.2212 10.8937 -7.32712 21.4541 -6796 4 19.2417 39.7541 15.0131 -1.99408 15.6159 -18.1773 -6797 4 17.935 39.549 14.2832 -4.44855 -3.57314 -3.37042 -6798 6 20.0977 14.0454 38.5561 35.4799 -67.417 -7.49733 -6799 4 20.2641 13.632 37.67 -9.31749 10.6865 24.2255 -6800 4 19.7827 14.877 38.3297 -23.7972 64.5272 -8.60678 -6801 6 22.6565 28.8842 34.0588 -5.52315 8.37947 20.7951 -6802 4 23.0585 28.228 33.4828 2.77778 -4.34029 0.307399 -6803 4 22.9395 28.703 34.9822 0.354749 -6.57221 -14.6515 -6804 6 22.6874 4.70198 5.2328 -25.042 -9.90055 15.5414 -6805 4 22.1274 3.9708 5.56882 12.1557 -0.0327816 -16.8284 -6806 4 22.5434 5.31639 5.94822 12.9551 16.3877 4.62095 -6807 6 23.6492 33.9942 38.3998 23.375 33.8394 -43.1733 -6808 4 22.8011 33.6715 38.57 -44.227 -25.7371 21.164 -6809 4 23.4749 34.4069 37.5183 19.103 -7.547 16.6445 -6810 6 48.374 21.3549 17.2744 -0.727013 41.2048 -23.9838 -6811 4 48.2041 22.3166 17.0448 3.0192 -25.1475 26.0409 -6812 4 48.3509 20.9743 16.3868 -2.31832 -8.94154 10.8829 -6813 6 11.5758 10.9938 8.63273 -18.0621 42.8191 15.9647 -6814 4 11.6313 10.2483 9.25156 -2.19238 1.01339 1.87179 -6815 4 11.0547 11.7764 9.03291 21.9333 -36.8133 -6.7089 -6816 6 40.0924 28.1686 33.4857 17.1635 -5.37387 30.2378 -6817 4 41.046 28.3881 33.5354 -13.2006 -3.32107 -11.2861 -6818 4 39.7443 28.4933 32.6629 4.51627 6.28126 -11.3213 -6819 6 47.3837 25.6703 5.29617 28.7657 21.9065 -4.48206 -6820 4 46.461 25.5322 5.12569 -20.8862 2.51482 -4.893 -6821 4 47.6179 26.6114 5.08959 -12.3293 -15.1007 -0.275896 -6822 6 21.6517 35.2222 23.996 27.7917 10.3485 -3.89698 -6823 4 21.6311 34.5383 24.6593 -10.5502 -12.8786 6.64496 -6824 4 22.5954 35.4881 23.9966 -15.7417 2.23004 -2.6139 -6825 6 8.24409 41.4919 8.41354 9.22969 12.4334 -12.8549 -6826 4 8.15 40.8674 7.67873 -1.07657 -2.81584 5.48771 -6827 4 7.83543 41.113 9.18983 -1.52095 -3.2343 5.88405 -6828 6 16.4798 31.1082 22.2131 -4.24513 -17.8742 -2.35359 -6829 4 17.0752 30.8161 21.5077 -7.18137 4.28218 -7.0656 -6830 4 17.0564 31.1902 22.9696 5.97679 -0.907857 10.4567 -6831 6 54.7122 0.459271 28.3177 -16.7834 -37.5181 -6.57119 -6832 4 0.641958 0.15455 28.3975 4.09167 16.1916 -1.73275 -6833 4 54.5379 1.34634 28.6236 20.797 14.6923 4.72985 -6834 6 48.4477 15.3762 4.17752 -7.35125 -30.0531 -4.44848 -6835 4 49.1738 15.1128 4.81019 -14.8803 0.337287 -24.8229 -6836 4 48.0902 14.5922 3.6288 23.2827 31.0113 24.8784 -6837 6 34.3541 7.00171 40.4295 26.6588 -46.9533 -23.8625 -6838 4 33.6168 6.99428 39.8319 -14.4938 10.2897 -3.98371 -6839 4 34.9839 6.35967 39.9588 -19.3291 28.4488 24.7248 -6840 6 41.3507 3.37676 17.0028 -19.6969 -26.4955 -6.96819 -6841 4 41.02 2.66518 17.5936 5.53648 12.9859 -1.78552 -6842 4 41.944 3.90566 17.5305 10.5068 9.85924 8.73726 -6843 6 48.4427 20.685 14.5419 46.8112 -36.6841 26.4704 -6844 4 48.0177 21.3487 14.0717 -32.7597 47.8552 -32.6818 -6845 4 49.3877 20.9188 14.5227 -9.08294 -4.43462 -1.64124 -6846 6 52.4922 28.1277 37.1182 6.87418 8.84651 -10.3419 -6847 4 53.4134 28.4024 37.0408 3.12987 -6.6922 4.15316 -6848 4 52.2752 27.8963 36.2007 -7.47166 7.06161 9.73328 -6849 6 53.8774 18.5638 18.79 -18.2161 -77.5341 7.0005 -6850 4 54.7018 18.1425 18.5274 3.76082 -0.315502 -3.76089 -6851 4 54.0435 19.4528 18.7445 16.4561 77.5259 -2.54699 -6852 6 41.0011 39.1407 28.7879 -31.3786 -4.09579 71.7092 -6853 4 41.3911 39.2094 27.9661 28.9736 8.71878 -68.6315 -6854 4 40.0521 39.3021 28.7019 -2.27612 -3.41331 -6.23213 -6855 6 38.2743 8.75074 24.2285 24.5029 -7.68366 -19.8132 -6856 4 39.1919 8.60362 23.8621 -28.3827 4.68959 18.7737 -6857 4 38.3545 9.42009 24.9092 0.456349 2.35846 11.2764 -6858 6 2.99111 29.1615 9.6319 43.2691 -54.6401 14.341 -6859 4 2.5338 28.6319 8.99687 -12.0219 1.86489 -18.3516 -6860 4 2.58318 29.9865 9.638 -27.8835 49.5023 8.75508 -6861 6 27.5756 29.2755 18.3378 -4.01048 -11.7045 41.1881 -6862 4 26.7643 29.1652 17.8389 -11.7278 -2.11582 -9.62984 -6863 4 27.2839 29.0037 19.2864 20.9622 13.2114 -52.0932 -6864 6 11.8501 21.1733 10.1172 4.58733 -51.566 26.4002 -6865 4 12.2099 22.0246 9.9906 13.4732 33.828 -10.0235 -6866 4 12.4495 20.7458 10.776 -15.5727 16.0367 -15.8372 -6867 6 16.9004 32.2989 0.299881 0.133752 -22.2186 -6.7835 -6868 4 17.7029 32.7095 0.626455 9.4749 11.3588 3.4417 -6869 4 16.2118 32.9605 0.285394 -3.66285 20.1796 -4.1714 -6870 6 1.30064 17.4766 22.5523 32.9941 -5.4384 -19.965 -6871 4 1.2446 16.5356 22.2294 -6.1018 21.6977 3.5382 -6872 4 2.22906 17.8023 22.3815 -23.7878 -13.737 8.2324 -6873 6 41.5474 6.85538 29.3077 15.2611 30.5857 3.861 -6874 4 41.7413 5.96016 29.5642 -1.91107 -14.5726 0.121693 -6875 4 42.0251 7.37916 29.9826 -12.8279 -1.76094 -5.06557 -6876 6 10.5087 10.782 13.8577 27.0965 -13.6956 13.3978 -6877 4 10.7007 11.2274 13.0253 -2.16043 3.73872 -7.98734 -6878 4 11.2742 10.169 14.0479 -24.5023 11.0776 -3.5626 -6879 6 39.8289 15.4978 40.8346 25.2099 1.13818 0.661387 -6880 4 40.0487 16.0673 40.0758 -9.90377 -2.84048 2.34508 -6881 4 40.6829 15.4254 41.3222 -18.4618 6.82556 -4.74882 -6882 6 26.5164 19.6052 40.5088 -9.33805 1.61856 -11.7217 -6883 4 27.41 19.9717 40.4897 0.274496 -7.70925 5.49567 -6884 4 26.4209 18.9712 41.2422 6.64723 7.57269 5.06511 -6885 6 54.036 8.18782 13.7715 27.5212 34.9045 -2.54262 -6886 4 54.5316 7.46918 14.1378 9.61628 -19.3806 0.327355 -6887 4 53.1925 7.88218 13.5309 -39.9219 -15.1658 -7.5943 -6888 6 15.6949 25.3434 10.6718 -31.7842 -7.37099 0.0612328 -6889 4 15.1805 25.3333 9.84403 14.6699 1.30202 -4.92807 -6890 4 14.9666 25.3615 11.3188 15.8696 -4.15214 -3.47235 -6891 6 18.5987 3.44175 21.9294 71.7321 -9.69418 15.9409 -6892 4 19.6071 3.44542 22.1959 -64.1569 1.8736 -14.3483 -6893 4 18.6296 3.58776 20.9721 -7.77871 5.49431 4.81248 -6894 6 50.8883 20.6265 18.5187 28.1172 41.6529 17.9746 -6895 4 50.1573 21.1733 18.1958 -9.23125 -9.06144 -4.34911 -6896 4 51.4834 21.2842 19.0045 -23.468 -29.5191 -15.1667 -6897 6 53.3673 20.9038 31.2869 -12.1652 -1.18869 -3.23134 -6898 4 53.2409 20.9073 32.2442 5.88471 -1.70994 -0.407299 -6899 4 52.4717 20.8062 30.9053 11.2743 1.61965 3.90294 -6900 6 52.8102 27.6189 28.9831 -34.4743 -7.30027 30.0453 -6901 4 52.2848 27.4362 29.7987 1.4862 0.901255 -27.4551 -6902 4 53.4947 28.1361 29.3473 35.4934 25.3811 1.80223 -6903 6 33.3112 15.6955 11.3264 12.7704 9.00306 37.7013 -6904 4 33.4999 16.1238 12.2198 -3.00415 -23.4283 -28.8796 -6905 4 32.4346 16.0003 11.1059 -7.33456 8.94646 -4.12361 -6906 6 20.3875 26.8057 27.4813 21.213 -4.31231 15.2493 -6907 4 19.6396 27.3594 27.2578 -2.8557 9.66202 -0.370116 -6908 4 20.9667 27.2946 28.1279 -24.4059 -13.8952 -19.2793 -6909 6 8.54399 2.06163 14.1713 4.36483 17.1543 -0.299448 -6910 4 8.13837 1.20516 14.196 -9.47708 -17.773 2.17407 -6911 4 8.01805 2.60085 14.7902 6.78451 -6.83093 -3.12033 -6912 6 40.1002 7.56575 40.6778 12.4019 9.60944 38.6013 -6913 4 39.712 8.14959 41.3779 4.03526 -4.70584 -30.6789 -6914 4 40.8329 7.16354 41.1893 -8.78874 -6.51591 -16.4763 -6915 6 6.89044 6.83556 10.7869 16.1514 15.8461 -3.23426 -6916 4 7.31622 7.70217 10.5979 -16.164 -15.6489 3.8938 -6917 4 7.04178 6.69918 11.735 -3.2221 -0.411834 -4.21297 -6918 6 31.2643 6.58983 20.136 22.5576 -57.6677 6.94967 -6919 4 30.6637 5.92034 20.5005 -2.47046 2.78164 8.35653 -6920 4 30.7152 7.30056 19.9711 -35.0351 52.1138 -11.6241 -6921 6 54.5411 21.0454 27.2925 4.1013 -43.0328 84.8338 -6922 4 0.071192 20.2129 27.5399 -15.6737 30.1382 -21.2093 -6923 4 54.6532 21.3072 26.4181 12.1035 8.54749 -60.3726 -6924 6 4.75213 23.1508 16.2245 -49.4139 4.34438 -28.0546 -6925 4 4.2471 24.0009 16.1592 20.3634 -17.2761 5.59937 -6926 4 5.4972 23.3136 16.7675 27.2932 5.42097 22.4316 -6927 6 25.5515 11.0241 14.8358 9.2665 0.546345 5.2197 -6928 4 26.0976 10.3608 15.3182 -9.73323 12.0118 -14.516 -6929 4 25.8683 11.8947 15.1133 0.0398252 -5.90721 -2.6003 -6930 6 41.1974 41.7784 29.942 -27.7855 -7.97533 -10.6302 -6931 4 40.9203 40.8727 29.6366 8.3922 29.767 6.72032 -6932 4 40.4023 0.465719 29.8931 18.9924 -15.525 2.17149 -6933 6 52.2793 15.2936 41.6313 19.4314 -9.06844 -20.2837 -6934 4 51.991 15.9601 0.331443 -10.9307 10.9541 10.4228 -6935 4 51.6032 14.6231 41.5544 -13.8311 -6.7739 0.824233 -6936 6 37.7418 21.7882 37.8505 9.73059 24.2058 3.49681 -6937 4 37.8176 20.8655 37.6583 6.26781 -24.8638 0.142384 -6938 4 38.1128 21.8753 38.7352 0.661952 0.248137 2.40564 -6939 6 23.8436 9.73697 27.5598 -17.3101 -56.824 -21.1542 -6940 4 23.6823 8.97924 26.8635 13.0753 42.6322 38.797 -6941 4 23.3674 9.48178 28.3892 6.27388 8.11738 -19.7561 -6942 6 43.0121 28.0431 32.8137 29.5034 -18.022 1.83467 -6943 4 42.9555 27.148 33.1715 -16.7807 6.42622 4.12236 -6944 4 43.9561 28.0675 32.5908 -15.6612 14.0802 -2.62256 -6945 6 34.1451 21.2362 11.9042 -10.4207 -39.0944 -3.26361 -6946 4 33.7785 20.3444 12.1585 8.75301 27.3815 0.918114 -6947 4 33.7383 21.3833 11.0382 -2.92284 10.3561 2.31655 -6948 6 10.5016 31.8267 10.0873 5.91889 6.7472 5.74276 -6949 4 10.9186 32.6594 10.3946 -11.2895 -14.4825 -9.55855 -6950 4 9.99233 32.0033 9.274 9.03923 7.50024 8.93884 -6951 6 35.8744 37.1309 22.1208 9.07655 -0.20125 -37.6945 -6952 4 36.7757 37.5102 21.9868 -16.2539 -8.14962 7.83623 -6953 4 35.5893 37.243 23.0078 -0.963312 7.56509 34.0991 -6954 6 27.293 4.59192 27.4599 -62.9251 -2.97268 8.43797 -6955 4 27.8573 4.63875 28.2367 1.75868 -0.322614 6.7695 -6956 4 26.3027 4.46726 27.7774 60.9698 2.85981 -12.9146 -6957 6 39.0165 22.2861 10.6525 -25.2911 9.99335 20.5692 -6958 4 39.5938 21.9801 9.97437 16.8498 -5.94336 -19.6369 -6959 4 38.1468 22.3658 10.2352 2.38909 -7.32087 0.337973 -6960 6 30.765 39.1813 10.9358 -26.8864 17.0789 0.421318 -6961 4 31.7273 39.1993 11.0368 0.254075 -10.0442 -6.8497 -6962 4 30.3957 38.288 10.8473 24.5485 -0.522695 0.476538 -6963 6 44.5972 26.9475 2.20695 17.6159 -27.9211 -0.145864 -6964 4 44.8477 26.0903 2.61727 -13.9349 20.2639 -7.87324 -6965 4 45.3006 27.0404 1.55025 0.322606 15.9 1.66232 -6966 6 23.7817 14.549 26.4845 -13.1218 37.1912 -28.6876 -6967 4 23.5085 15.1786 25.7375 18.3344 -26.327 26.4977 -6968 4 23.2314 13.7794 26.3439 -3.10125 -8.02717 6.138 -6969 6 38.3349 13.3785 39.6531 51.0719 11.8768 18.627 -6970 4 39.1134 13.8424 40.1004 -28.3003 -20.0613 -21.9332 -6971 4 37.637 14.0102 39.7945 -20.9869 -1.09015 1.55638 -6972 6 17.9076 17.2343 29.3998 2.5182 -11.8623 9.07057 -6973 4 17.7005 16.8028 28.5679 -0.208052 -3.06359 -6.42367 -6974 4 17.2973 17.9612 29.4206 -13.3644 14.2602 6.84169 -6975 6 17.427 29.8312 9.9167 5.70667 9.14636 11.5297 -6976 4 16.5259 29.8398 9.63655 -18.5043 -5.93208 -2.5299 -6977 4 17.9097 29.6705 9.11934 16.3543 -3.78316 -10.6623 -6978 6 35.6302 6.05705 19.6249 -12.632 -1.17761 -30.1407 -6979 4 35.1756 5.57436 18.904 4.12491 -0.359791 14.6292 -6980 4 35.7342 6.9119 19.1826 9.40393 1.91765 12.7562 -6981 6 18.674 22.2857 17.523 8.42296 3.39096 21.1197 -6982 4 17.7402 22.4481 17.6821 -9.17854 0.615652 -6.61815 -6983 4 18.8674 22.3747 16.5992 -7.41694 3.44878 -20.9034 -6984 6 20.0258 3.81405 32.2871 -5.45876 10.2161 0.982716 -6985 4 19.684 4.03807 31.424 -2.67861 3.00481 -7.64614 -6986 4 20.9375 3.54321 32.099 -1.59169 -5.33194 9.42598 -6987 6 5.47094 6.98417 8.10987 -1.95658 -27.204 5.03178 -6988 4 5.85072 7.84658 8.088 3.96324 28.039 -6.11929 -6989 4 5.94584 6.55919 8.82772 -3.50663 -6.33739 10.9422 -6990 6 44.182 20.5312 25.5979 43.1361 -13.705 -19.148 -6991 4 44.6875 21.1042 26.1493 -15.9255 27.6084 29.7698 -6992 4 44.9726 20.2272 25.1253 -26.0739 -14.4287 -20.9555 -6993 6 43.9621 36.9892 17.8709 27.7049 17.1418 -9.42399 -6994 4 44.6647 37.4643 17.3692 -13.724 -4.61297 12.4448 -6995 4 43.6121 36.3808 17.225 -14.1002 -14.0328 0.985329 -6996 6 34.6183 10.1148 16.2555 -4.96303 14.2933 -37.1542 -6997 4 34.4099 10.1014 15.264 7.63186 -7.52385 38.4141 -6998 4 34.6455 11.0716 16.4378 1.03434 -4.81203 3.48645 -6999 6 23.6535 3.43617 1.32551 9.32991 -27.0385 -60.023 -7000 4 23.5361 2.47498 1.09872 1.70789 26.2755 24.74 -7001 4 23.8607 3.79652 0.414552 -11.3127 6.44054 37.9529 -7002 6 33.4225 38.9606 5.09116 -45.0556 15.9463 14.7537 -7003 4 32.9187 38.171 4.91655 10.2233 -24.4058 -4.43744 -7004 4 32.6531 39.5198 5.39063 34.9247 3.3662 -8.43025 -7005 6 22.5542 32.508 35.8091 -1.62577 21.6885 -22.4452 -7006 4 23.4313 32.1432 35.8321 13.5304 -8.64793 9.08541 -7007 4 22.6972 33.4304 35.4917 -7.91418 -12.6316 15.6694 -7008 6 32.4209 37.2696 13.8263 22.6153 37.4816 -15.7005 -7009 4 31.6314 36.8608 13.5507 -35.0264 -17.3769 -13.0658 -7010 4 32.7321 36.7183 14.5153 12.3601 -27.6025 17.2047 -7011 6 52.6048 12.7515 39.5965 -13.8302 -6.28036 -1.32475 -7012 4 53.26 13.3571 39.2655 9.70847 9.80763 -6.22213 -7013 4 53.0114 12.2827 40.3245 7.10516 -3.61819 3.538 -7014 6 28.8284 14.5654 1.23244 38.3097 18.383 -14.9432 -7015 4 28.2834 13.8143 1.34735 -23.3809 -22.0338 3.15251 -7016 4 28.3672 15.33 1.56727 -9.74512 0.414323 3.22557 -7017 6 1.45359 32.4205 23.3989 -1.05001 -40.1011 -18.1189 -7018 4 1.47013 31.5606 22.9188 -1.41837 10.7967 19.8874 -7019 4 1.97354 32.9442 22.8182 11.5552 29.203 -12.5869 -7020 6 54.3296 23.3325 28.9716 1.50467 4.34178 0.834044 -7021 4 54.2574 22.8567 29.7964 -0.193368 0.82753 11.1745 -7022 4 54.4723 22.6371 28.331 0.325397 -5.40149 -8.07104 -7023 6 14.3127 12.1509 35.6633 -33.5663 -10.8168 -13.6472 -7024 4 14.2878 12.7047 36.4184 6.74358 21.3133 20.6565 -7025 4 15.1756 11.8015 35.6107 35.8459 -8.25269 -4.05635 -7026 6 18.9986 6.53226 41.2771 -21.1361 -24.8418 -24.3627 -7027 4 18.366 5.78703 41.1105 9.63211 18.6573 18.8829 -7028 4 19.3119 6.48514 0.272589 3.11598 2.01554 11.5533 -7029 6 5.32991 17.8836 20.3428 -30.4167 16.0599 6.69424 -7030 4 4.7967 18.411 19.709 2.93149 -9.05217 4.33299 -7031 4 4.77097 17.8526 21.1546 15.0176 4.61027 -13.5236 -7032 6 24.7236 34.9657 30.1688 -3.59195 -26.0802 -14.261 -7033 4 24.7803 35.9013 30.0428 5.00342 21.1487 3.94382 -7034 4 24.6904 34.5809 29.2706 1.13339 13.2018 12.9935 -7035 6 31.868 4.6188 18.1813 26.0749 -11.7783 -2.21043 -7036 4 31.7807 5.26575 18.8694 -2.85928 14.415 8.06415 -7037 4 31.0011 4.54965 17.8036 -17.7428 -0.954819 -5.29079 -7038 6 8.70915 17.4782 5.92977 -5.10088 36.478 0.166614 -7039 4 7.99285 18.1665 5.8727 10.0003 -20.7449 -0.10219 -7040 4 9.53277 18.014 5.87919 -8.17468 -12.6369 7.06335 -7041 6 29.8448 10.9674 14.467 -9.24737 10.8237 6.24964 -7042 4 29.3518 11.4625 13.8111 -3.5417 -3.22768 -11.9456 -7043 4 29.8741 11.602 15.1948 7.6561 -6.41884 12.5924 -7044 6 48.7193 10.2987 32.5837 48.7914 -16.5053 -5.27468 -7045 4 48.664 9.84191 33.449 -1.5926 15.0761 -9.20872 -7046 4 49.6917 10.1556 32.2801 -49.2626 10.4163 8.33251 -7047 6 8.33128 15.6672 37.865 4.36755 4.12409 -33.9682 -7048 4 8.08142 16.0688 38.661 -6.22033 14.9054 48.1983 -7049 4 7.78443 16.1766 37.2488 7.82296 -4.92397 -7.06368 -7050 6 50.3849 3.07587 17.3306 53.0616 0.797084 -5.54454 -7051 4 49.9901 2.96071 16.4818 -23.7547 4.5323 -14.3202 -7052 4 49.831 3.21284 18.0832 -29.2444 4.71684 15.357 -7053 6 14.687 38.3962 10.9034 11.8452 2.26847 -28.7684 -7054 4 14.4993 38.5723 11.8231 -13.1425 0.700252 11.382 -7055 4 14.2628 37.5785 10.602 -2.45756 1.24341 13.1034 -7056 6 34.1174 6.37976 10.8168 12.9161 5.50138 13.5595 -7057 4 34.1292 7.23477 10.3416 2.23773 -14.4836 1.59416 -7058 4 34.9287 6.34152 11.3848 -14.7297 9.70771 -12.8953 -7059 6 7.1619 37.5492 17.6341 50.2032 -5.81562 0.15107 -7060 4 8.17599 37.5098 17.465 -47.7372 -0.307972 7.49553 -7061 4 7.05745 37.0565 18.4805 -8.53445 9.44148 -12.9936 -7062 6 51.515 11.3168 16.7982 -26.0757 5.86397 -27.0874 -7063 4 52.235 10.8459 17.1551 30.0977 -19.3818 20.7126 -7064 4 51.5008 11.0547 15.8562 -2.22905 10.0255 8.80825 -7065 6 15.6633 8.64974 3.19872 2.04011 -21.0584 -36.8111 -7066 4 15.359 9.2987 3.81038 -7.3063 19.0886 25.5551 -7067 4 16.1924 8.00887 3.67257 5.32849 -2.14206 7.59436 -7068 6 5.43671 21.4488 11.9213 -35.1135 30.2715 2.68526 -7069 4 5.1197 22.3031 11.5306 26.1226 -15.3225 -1.30607 -7070 4 4.71321 21.2794 12.5494 12.8867 -7.97314 3.40019 -7071 6 50.1888 24.041 37.9733 -16.5158 11.6838 -8.72192 -7072 4 49.5513 24.2503 37.2525 13.6843 -9.6942 16.9361 -7073 4 50.7608 23.3204 37.7156 0.52347 -2.66969 -5.08066 -7074 6 39.7366 11.2383 31.6978 23.7892 31.0409 -10.9794 -7075 4 40.3477 11.919 31.322 -8.85632 -23.7146 9.45819 -7076 4 38.8907 11.643 31.516 -11.7678 -2.00245 1.00495 -7077 6 26.6862 10.831 20.5846 -4.64528 13.8134 22.6501 -7078 4 26.37 11.3609 21.3584 5.46785 -6.26709 -23.7021 -7079 4 26.5097 9.94471 20.9062 3.28762 -9.42115 -6.7075 -7080 6 12.5617 17.5693 18.1619 57.3415 -16.6047 -35.4946 -7081 4 12.3732 16.6356 17.927 -10.1847 12.7431 11.2408 -7082 4 11.9536 17.9401 18.7496 -47.3477 6.23269 31.2745 -7083 6 47.7779 31.603 17.3345 -16.0229 -2.6295 -18.0517 -7084 4 48.4774 31.3981 17.9449 0.342859 -12.7175 10.4199 -7085 4 47.3751 30.7658 17.0144 6.51745 15.1025 2.87388 -7086 6 1.06661 3.38166 18.5387 0.482315 1.39351 -20.5486 -7087 4 1.47214 3.81044 19.3024 -7.19452 2.23946 8.83247 -7088 4 0.121217 3.21323 18.6865 2.92702 6.89788 10.7589 -7089 6 26.5916 20.3882 15.3141 4.05487 -19.1164 -7.10575 -7090 4 27.0276 19.5492 15.0037 -7.93965 16.9744 10.3813 -7091 4 25.6772 20.1067 15.4922 9.40368 -0.641397 -3.80974 -7092 6 42.0092 3.03717 36.7607 9.58516 7.42569 -27.539 -7093 4 41.472 2.27114 36.5289 -4.68032 -10.5632 12.6255 -7094 4 41.9749 3.27199 37.6769 -10.2045 -8.66607 25.0137 -7095 6 39.3197 22.4482 33.2161 17.1359 -6.1719 -1.11969 -7096 4 39.6777 22.5385 34.1471 -14.6651 4.73191 -34.7467 -7097 4 39.2891 23.3308 32.7977 1.66572 -7.01471 12.3298 -7098 6 18.4983 34.959 11.9233 -52.4092 11.8234 -6.15541 -7099 4 19.3311 34.9297 12.2931 62.358 -5.27325 28.8625 -7100 4 17.9525 35.2018 12.6795 -15.7268 -2.39727 1.11957 -7101 6 22.849 14.1156 0.206953 9.43339 -22.8796 20.8561 -7102 4 23.1273 14.7687 41.4941 9.338 18.1693 -9.76493 -7103 4 23.4344 14.2183 0.991573 -8.36464 7.13735 -11.7533 -7104 6 31.0127 16.6435 33.7717 -75.3989 -12.3916 10.6429 -7105 4 30.4261 16.8588 33.0132 20.7291 0.745933 12.1228 -7106 4 31.8948 16.7604 33.5238 39.9201 13.7608 -15.1754 -7107 6 28.4056 35.5121 5.54765 -4.91817 12.0412 -0.933493 -7108 4 29.0647 34.8486 5.74161 15.0982 -5.96625 -1.02933 -7109 4 28.8561 36.3656 5.44297 -1.6946 -6.58589 1.12865 -7110 6 2.06022 31.4415 10.6404 20.6415 1.38777 10.2498 -7111 4 2.4899 32.1989 10.2195 -2.44284 -2.19106 -3.22737 -7112 4 1.13111 31.6267 10.6164 -17.6565 -0.143118 -7.1498 -7113 6 5.95467 9.75858 21.3545 2.17354 8.87983 -50.8842 -7114 4 6.2643 10.5435 20.7894 -11.3634 -34.5597 22.4005 -7115 4 5.48441 9.14719 20.7121 9.8282 23.6666 23.1144 -7116 6 24.7866 26.6177 2.6661 -24.4024 -28.5469 2.9707 -7117 4 23.9476 26.6963 2.18158 9.10826 11.4817 -7.6186 -7118 4 24.6214 25.7954 3.1805 15.5163 19.2379 2.11057 -7119 6 45.7515 4.24664 18.6084 -0.948574 6.19926 2.59566 -7120 4 46.4738 4.91595 18.5123 -9.05862 -19.7882 -0.326833 -7121 4 46.0843 3.34349 18.421 4.31178 15.089 3.21664 -7122 6 4.45878 0.783326 15.9106 20.8465 2.39674 -2.22601 -7123 4 4.33336 41.7534 15.8294 -11.1347 -14.3847 -2.31303 -7124 4 5.37758 0.813141 16.2285 -10.0444 13.1447 -0.149196 -7125 6 2.44065 19.4988 25.3899 -18.2163 -19.9205 28.2208 -7126 4 1.89428 18.9873 26.0273 4.60516 17.0002 -8.33323 -7127 4 2.55045 18.8717 24.6878 9.48029 -1.77855 -17.0048 -7128 6 40.6027 8.48954 5.10826 -27.6355 -21.4881 -13.6167 -7129 4 40.6592 9.31425 5.57088 10.9479 16.5697 14.8472 -7130 4 41.3781 7.96424 5.30637 14.4251 2.68711 -2.52113 -7131 6 49.3092 22.3481 41.5186 -9.93734 74.0457 16.0776 -7132 4 48.4971 22.7919 41.1786 21.3857 -10.289 -0.267672 -7133 4 49.2285 21.4633 41.2985 -4.59952 -62.95 -16.8011 -7134 6 0.364483 40.9333 20.5966 -24.8933 -11.8265 -30.66 -7135 4 0.190818 39.9667 20.5681 4.35782 8.08342 1.06674 -7136 4 54.6936 41.3396 19.9676 13.1862 -7.22974 19.6204 -7137 6 34.8864 15.3279 38.0452 -17.1782 37.3505 -55.2903 -7138 4 34.2682 16.0872 37.9321 5.94042 -16.3876 6.60377 -7139 4 35.3697 15.4116 37.1797 -1.56134 -6.74346 24.1748 -7140 6 7.76223 25.9987 29.8652 25.7268 -8.51605 -4.95409 -7141 4 8.61839 26.4638 29.9588 -13.1921 -1.71741 1.7916 -7142 4 8.05672 25.0651 29.9772 -19.4202 16.3818 3.54783 -7143 6 40.7182 22.7954 20.4441 37.8127 13.8011 -33.8007 -7144 4 41.3586 23.4588 20.0133 -28.9149 -26.2189 23.8294 -7145 4 40.2017 23.2969 21.0583 -10.7099 15.3396 13.8501 -7146 6 37.6932 25.6399 36.0638 4.62997 10.0285 35.1853 -7147 4 38.3287 24.9236 36.1183 -2.20273 -4.01008 -9.65359 -7148 4 37.2914 25.6394 35.2107 -7.09628 -5.12362 -31.4654 -7149 6 5.46101 24.0014 10.2586 17.9799 16.5872 6.22131 -7150 4 6.04134 23.844 9.49543 -11.5162 -2.35388 5.85767 -7151 4 5.90746 24.7967 10.672 -23.415 -30.7572 -16.8601 -7152 6 48.4104 21.0451 38.1819 10.5351 27.9197 -28.7006 -7153 4 48.793 20.7803 39.017 13.2175 -6.38321 0.209366 -7154 4 49.1228 21.3802 37.5459 -28.8109 -18.4864 30.6779 -7155 6 15.2906 25.011 3.54101 2.70625 6.69817 -9.95824 -7156 4 15.4569 24.0555 3.50682 -9.52162 -0.514188 6.9158 -7157 4 14.6826 25.2483 4.2581 -1.83637 -10.9582 1.3864 -7158 6 46.3949 40.2718 20.0841 3.05266 -42.5213 0.389481 -7159 4 46.7282 39.319 20.1688 -17.5494 37.8624 -2.40649 -7160 4 47.138 40.8016 20.3323 14.2597 18.5668 -0.122304 -7161 6 34.6662 36.4732 0.324161 -52.0076 35.1593 -1.38074 -7162 4 34.82 35.9689 1.09464 17.4812 -18.6855 30.1307 -7163 4 33.7817 36.8781 0.601954 33.7085 -7.09846 -24.72 -7164 6 52.5968 8.00424 30.4116 -30.791 -5.83914 -1.44892 -7165 4 52.0396 8.66036 30.8559 12.8564 7.40177 -0.477247 -7166 4 51.9287 7.58179 29.8369 22.2614 -6.63703 0.63559 -7167 6 32.0772 3.86049 29.4688 -16.0025 -7.01815 -35.05 -7168 4 31.5382 3.03776 29.5615 20.8838 14.671 -1.22835 -7169 4 32.0904 4.03293 28.4798 -1.86833 -11.5506 40.3284 -7170 6 20.363 17.8245 28.646 3.47804 13.7512 -7.92665 -7171 4 19.5516 17.4966 29.0653 6.53113 9.74715 -6.36853 -7172 4 20.0825 18.3002 27.8308 0.555567 -8.90179 15.8758 -7173 6 30.4041 41.1634 41.0132 -16.7253 12.0993 -9.83452 -7174 4 30.5197 40.835 40.1072 4.71307 -5.7925 7.34595 -7175 4 31.1703 40.9637 41.5368 18.7313 -7.07732 1.06037 -7176 6 35.4542 32.8539 27.9215 21.6406 26.5455 -21.3275 -7177 4 35.1435 33.2362 28.7432 -6.21594 5.85967 7.97646 -7178 4 35.8745 33.6007 27.3754 -13.2283 -32.0923 16.9769 -7179 6 14.39 6.67952 12.731 -12.5058 36.491 0.424373 -7180 4 15.2321 6.28981 12.9462 8.74388 -6.1299 -2.75421 -7181 4 14.5067 7.66796 12.7988 -3.69921 -34.1177 -6.56265 -7182 6 41.8739 41.5433 20.319 24.4238 12.2951 6.29746 -7183 4 42.7192 41.2715 19.9184 -11.0628 6.38436 -6.30872 -7184 4 41.3184 40.7767 20.2955 -10.4459 -12.1473 -5.48062 -7185 6 46.3985 22.5739 8.8638 6.84921 19.3184 1.79378 -7186 4 45.8729 21.8991 8.42669 -3.07803 -12.5032 3.12866 -7187 4 47.1271 22.1566 9.33065 -8.50589 -8.34396 1.5145 -7188 6 17.4023 20.6526 13.9004 10.6995 28.5611 -11.4854 -7189 4 17.6978 21.6036 13.9579 -8.84666 -31.3302 7.07381 -7190 4 17.3123 20.5004 12.9448 0.490636 -3.23538 4.08121 -7191 6 8.20126 9.48382 13.3485 -42.4293 41.8522 17.2798 -7192 4 7.44487 10.0964 13.6076 19.5538 -29.8853 -13.4391 -7193 4 8.9576 10.0119 13.6277 13.7224 -9.45646 -1.54211 -7194 6 7.58554 14.8008 29.5824 -2.61798 9.90858 -2.64866 -7195 4 7.05733 14.3538 30.2458 -0.514214 1.68252 7.63674 -7196 4 7.01989 15.5029 29.2149 4.91731 -6.06465 -0.976267 -7197 6 29.5668 39.2268 22.6285 -3.66094 -2.39634 13.3419 -7198 4 29.8353 38.7557 23.4169 -4.20308 -7.76017 12.2752 -7199 4 30.3745 39.2765 22.1369 12.5997 4.36069 -18.8462 -7200 6 19.725 28.7952 8.44488 15.8543 2.58223 -4.45186 -7201 4 19.5131 27.8757 8.63421 -2.81313 1.38303 -4.16069 -7202 4 20.6983 28.808 8.54393 -13.7447 6.84799 3.59225 -7203 6 20.0995 21.6275 25.9249 -17.5249 50.4223 5.09745 -7204 4 20.7082 22.0204 26.5908 -8.84326 -18.264 -10.6066 -7205 4 19.3931 22.3347 25.9239 13.215 -30.9895 -3.48111 -7206 6 12.7711 16.1006 22.7986 17.0661 -2.75106 -3.7002 -7207 4 12.1316 16.7784 22.5952 -11.3059 6.43976 -4.8982 -7208 4 12.4647 15.3033 22.3372 -2.13756 9.04884 6.71194 -7209 6 7.09175 27.2069 17.991 -23.617 26.2366 -1.29155 -7210 4 7.8076 26.6007 17.9383 20.2011 -26.8554 -5.74897 -7211 4 7.19403 27.792 17.2318 3.33647 -0.0238245 -0.788587 -7212 6 32.3975 8.68618 34.8629 3.54321 22.8272 16.3539 -7213 4 32.7738 9.06402 35.707 -18.9002 -9.48773 -27.5474 -7214 4 31.4989 9.0701 34.6771 23.7457 -9.58556 9.46102 -7215 6 50.3515 28.2186 17.5351 -6.87553 0.519429 12.9107 -7216 4 50.2481 27.3572 17.999 6.5408 9.8464 -12.2276 -7217 4 51.0722 28.1417 16.8919 -2.26653 -7.3618 -1.59066 -7218 6 15.6741 32.1546 25.7968 -26.4348 -11.0143 -14.9159 -7219 4 16.4004 32.6083 26.1805 24.7846 13.6092 10.6573 -7220 4 15.1411 32.8481 25.3674 4.92309 -4.07512 11.5217 -7221 6 41.2877 22.001 29.6411 43.1174 -21.5596 15.2505 -7222 4 40.6305 22.5901 29.3541 -33.8214 23.827 -16.0773 -7223 4 40.8662 21.2212 29.998 -7.36398 -2.60921 4.02408 -7224 6 24.5416 12.7608 8.88206 5.17198 -11.9982 -20.3907 -7225 4 24.1774 13.5122 9.35398 1.69504 4.6425 -2.53241 -7226 4 24.2888 12.8675 7.94212 1.28664 -3.68024 15.0016 -7227 6 47.3025 20.1085 10.3977 1.21439 24.4816 37.2747 -7228 4 48.204 20.4596 10.4656 -0.7364 -8.12719 -10.3932 -7229 4 47.15 19.5905 9.61989 6.68365 -16.152 -23.0167 -7230 6 17.6916 14.2112 29.9613 0.736848 4.98565 -22.9932 -7231 4 16.8377 14.622 30.0672 -16.7241 9.37988 10.4211 -7232 4 18.1183 14.7557 29.2835 1.70081 -6.05446 6.16757 -7233 6 21.3481 34.5805 28.5342 -9.54463 9.82799 -20.865 -7234 4 21.5933 35.4178 28.0943 -1.05427 -4.62886 14.5387 -7235 4 21.7361 34.566 29.3968 13.4346 0.0141216 16.9261 -7236 6 35.1024 4.03924 4.01172 -45.5158 42.5484 12.3245 -7237 4 34.1858 3.89939 4.38295 32.1954 -12.7538 -7.33111 -7238 4 35.1016 5.02916 3.89259 9.91862 -26.8751 2.91657 -7239 6 29.9059 8.58368 22.6013 -13.5917 -22.6535 -48.6732 -7240 4 29.4773 8.30259 21.7189 15.3855 19.7125 42.6195 -7241 4 30.4378 7.8025 22.8052 -0.87874 9.41284 8.39762 -7242 6 9.78314 32.9658 15.9197 34.9354 -36.2496 39.6827 -7243 4 9.8463 32.0623 16.3137 -14.5131 14.3099 -26.4053 -7244 4 10.4229 33.3707 16.5321 -2.5459 17.7355 -14.0184 -7245 6 24.9212 14.2335 32.582 19.5351 -17.8621 25.1352 -7246 4 25.485 14.4356 33.3711 -14.9506 -0.509299 -20.0473 -7247 4 24.5508 15.0526 32.2925 -5.32053 16.7872 -6.18619 -7248 6 49.6539 21.965 26.2345 44.0267 25.2751 -8.97422 -7249 4 50.4399 21.435 26.5572 -22.3889 20.3635 -4.11669 -7250 4 50.0214 22.8598 25.9362 -18.5294 -37.2714 15.3372 -7251 6 39.2165 29.6282 28.7804 -1.72389 1.82743 -9.11301 -7252 4 39.3036 29.0201 29.5259 1.24025 -1.09654 1.55877 -7253 4 39.538 29.1266 28.0158 0.286751 -1.49672 5.82908 -7254 6 50.6899 34.7862 39.7499 25.3157 10.1005 12.0928 -7255 4 51.6472 34.6743 39.5192 -19.7186 -4.86584 -0.193213 -7256 4 50.1651 34.2508 39.1591 2.72681 -14.2758 -14.8682 -7257 6 29.2004 20.8742 19.5261 27.9811 -3.68804 20.7377 -7258 4 30.1466 21.1247 19.5553 -9.39276 -2.96688 2.79863 -7259 4 28.9246 21.1497 18.6738 -22.5466 15.5983 -24.0329 -7260 6 45.8438 1.42491 21.3861 -37.1737 6.40486 -10.0566 -7261 4 44.9885 1.11968 21.7285 6.97513 -0.0444158 -7.72874 -7262 4 46.4438 0.92117 21.8904 34.782 -15.8409 16.3481 -7263 6 26.1011 5.84859 12.9885 -16.9285 4.46913 -7.38549 -7264 4 26.5547 5.08441 12.6375 7.71787 -14.9735 6.0022 -7265 4 25.1614 5.66972 12.8036 4.71997 0.43883 -1.19571 -7266 6 9.00669 19.0403 23.7238 12.8928 30.373 -14.6892 -7267 4 8.06593 18.9071 23.7945 -12.9763 -5.98489 5.20443 -7268 4 9.0473 19.9093 23.2431 5.0983 -22.172 6.64837 -7269 6 47.6961 14.1782 40.0269 19.0377 9.97795 -11.4729 -7270 4 48.5222 14.3512 39.5239 -16.7083 -4.37767 10.6105 -7271 4 47.3795 15.0553 40.2888 -5.04524 -6.44815 -3.81417 -7272 6 47.9985 19.7874 0.500962 -66.9165 -27.0064 -39.4066 -7273 4 48.5513 19.9496 1.22397 26.1904 -2.55385 45.3318 -7274 4 47.2789 19.103 0.704655 34.6798 29.0788 0.973802 -7275 6 27.1606 39.6013 31.4318 -10.4761 -55.491 -38.6851 -7276 4 26.8926 40.2811 32.0159 -13.7359 20.3686 20.1783 -7277 4 26.3709 38.9998 31.2101 25.3937 25.349 18.055 -7278 6 20.7209 15.2822 27.3078 -0.805435 -7.71632 -8.78017 -7279 4 19.7876 15.3781 27.0487 8.25469 13.9731 2.34115 -7280 4 21.2532 16.0335 26.9925 -16.2498 2.55153 -4.46604 -7281 6 53.2722 3.12643 19.6849 41.3384 49.6686 7.26214 -7282 4 52.533 3.74254 19.7043 -8.02663 -2.92583 -3.0848 -7283 4 53.0086 2.23956 19.6703 -22.4403 -46.3419 -2.11618 -7284 6 40.7531 33.3786 24.0219 13.5521 -1.60379 23.9632 -7285 4 41.5067 33.1664 24.6167 -8.75803 3.71621 -14.936 -7286 4 40.1104 32.6626 24.1628 3.50492 2.6284 -2.95087 -7287 6 50.2066 37.8896 21.3771 44.4561 61.7722 -19.2089 -7288 4 50.9779 37.3435 21.496 14.3962 -14.5259 7.12428 -7289 4 49.4598 37.4098 21.5582 -59.0635 -51.549 13.7135 -7290 6 41.3233 2.3412 21.9924 -16.3503 12.7858 19.6024 -7291 4 41.3426 2.52207 21.0679 5.97541 2.4567 -21.4637 -7292 4 40.4663 2.75609 22.2585 17.532 -18.0725 0.252127 -7293 6 3.68867 21.2779 14.3383 -14.5707 42.5 -35.9941 -7294 4 4.12477 21.855 14.9587 9.56216 12.6885 8.47194 -7295 4 3.77328 20.4352 14.6935 9.76412 -50.205 23.6517 -7296 6 34.2782 11.1533 36.6146 -6.03132 -23.9347 13.7336 -7297 4 33.9924 10.5436 37.3334 13.9996 -4.78487 -21.5854 -7298 4 34.1172 11.978 37.0322 -7.62349 27.2634 9.28858 -7299 6 24.0533 21.9225 23.4615 4.73517 -5.47775 13.1649 -7300 4 23.9978 21.53 22.5886 6.00444 -6.53009 -8.74438 -7301 4 24.605 21.2935 23.9896 -10.4931 14.2472 -9.63662 -7302 6 18.8931 0.346665 4.41951 -1.70081 19.9518 7.76538 -7303 4 18.8368 41.3461 4.13842 4.04101 -8.25805 2.22226 -7304 4 19.3845 0.416823 5.25819 -4.2619 -8.11151 -12.0763 -7305 6 1.61167 7.82777 17.7295 14.4633 -7.55708 2.21629 -7306 4 1.68315 6.88308 17.5181 0.421421 7.02752 -3.81945 -7307 4 0.776664 7.94842 18.1735 -9.56642 1.01884 2.20602 -7308 6 9.88587 31.542 26.4865 27.4574 -58.0414 -32.6279 -7309 4 9.74723 30.8294 25.7579 9.18818 32.443 34.13 -7310 4 9.16596 32.1271 26.4328 -35.6644 31.0992 -1.66616 -7311 6 46.989 33.006 20.3636 -11.9681 -37.8677 44.1235 -7312 4 47.0707 32.5253 21.2626 7.56487 31.1056 -35.1941 -7313 4 46.435 32.3629 19.8924 4.61548 9.19147 -10.8851 -7314 6 49.5457 29.2916 21.3977 -38.7846 4.15079 -24.0209 -7315 4 50.3477 28.8236 21.2219 24.323 -7.55681 13.7085 -7316 4 49.5468 29.8542 22.1736 14.9668 -0.936193 10.2574 -7317 6 13.5153 31.8979 19.1528 13.8675 8.3184 29.6787 -7318 4 12.8458 31.9825 19.8587 16.0999 2.21739 -7.32054 -7319 4 14.3406 32.2634 19.5906 -25.0701 -6.26478 -24.6616 -7320 6 46.633 34.1066 16.9257 -0.036059 -36.1463 20.7227 -7321 4 46.8492 33.9929 15.9997 3.99258 8.43366 -10.882 -7322 4 46.9059 33.2223 17.3084 -4.9703 29.3867 -9.59361 -7323 6 19.7609 39.5392 2.42166 -7.20248 -0.896063 -14.0911 -7324 4 20.5606 40.0527 2.5788 -3.5749 4.99115 -1.28658 -7325 4 19.2738 40.0463 1.72337 11.6568 -15.7424 21.4794 -7326 6 16.5329 9.39795 28.3065 -12.6095 -8.72502 6.68605 -7327 4 16.4075 10.3536 28.3648 10.1088 3.80195 -3.74389 -7328 4 17.4502 9.20269 28.1082 11.2813 2.72217 -1.81406 -7329 6 3.0433 33.3643 8.96425 -4.92886 23.6682 -21.9772 -7330 4 2.41869 34.0757 8.74286 -2.57616 0.180013 17.6579 -7331 4 3.16376 33.0029 8.08154 7.55925 -16.3918 2.91827 -7332 6 49.6751 28.308 0.201579 -29.5359 7.30765 2.58258 -7333 4 50.5733 28.3754 41.8671 34.4717 0.327786 -9.88202 -7334 4 49.5726 27.4715 0.657175 -2.26504 -2.01296 8.34302 -7335 6 1.41619 6.84354 30.4994 -10.3235 0.0954103 3.42179 -7336 4 1.63397 7.74222 30.8225 4.19995 -13.4757 3.05915 -7337 4 0.761793 6.45905 31.124 14.5617 20.0187 -8.0296 -7338 6 19.7679 9.42131 33.717 -3.22882 -6.25654 -44.8315 -7339 4 19.9145 8.46604 33.7746 1.8774 1.59257 2.48781 -7340 4 19.5751 9.55831 32.7323 1.24521 6.76178 40.819 -7341 6 26.1724 11.919 3.61074 17.7641 10.7445 -19.8393 -7342 4 25.5356 12.1934 4.24073 -14.9718 14.8208 22.8097 -7343 4 26.0423 10.983 3.54915 1.55706 -20.7566 2.99847 -7344 6 33.2542 2.1444 18.2116 -1.15587 48.9982 3.93816 -7345 4 32.886 2.96086 18.6548 6.67205 -21.4839 -22.8104 -7346 4 32.6761 1.46025 18.493 -13.9253 -19.4899 6.26155 -7347 6 1.55797 29.1194 15.6221 -22.3111 36.2637 61.7506 -7348 4 0.853719 28.5449 15.936 -7.71843 6.28063 0.384394 -7349 4 1.90648 28.6788 14.9107 30.7784 -39.3832 -62.5327 -7350 6 41.7311 4.10421 39.5944 -40.7328 36.7616 -42.7174 -7351 4 41.3817 4.81242 38.923 27.6667 -38.3892 36.6931 -7352 4 40.9025 3.64602 39.8145 11.2401 -8.56921 5.26404 -7353 6 28.6823 41.7982 21.1955 47.2047 1.42594 -8.59686 -7354 4 29.177 0.720645 21.3267 -21.6507 -0.473723 0.486784 -7355 4 29.4617 41.2314 21.0003 -26.4876 -3.65191 3.02858 -7356 6 11.643 12.3982 35.4482 -35.2927 22.3423 -20.2863 -7357 4 11.5968 12.2307 36.3713 6.75035 -5.55932 30.2124 -7358 4 12.5522 12.401 35.2267 32.0712 -2.0845 -6.40416 -7359 6 9.80556 12.056 0.297197 42.0735 31.0338 -28.3715 -7360 4 10.6577 12.4693 0.65483 -33.0881 -22.384 -10.4034 -7361 4 9.20254 11.76 0.941289 -12.1624 -10.8407 36.4861 -7362 6 48.1632 12.393 9.2137 2.43833 7.21341 -5.5951 -7363 4 48.4522 11.811 8.50685 -9.57081 -7.25037 -8.94466 -7364 4 48.8896 12.3474 9.83523 7.41749 2.43397 12.8852 -7365 6 20.1331 24.378 18.9556 11.9182 2.36756 -38.9603 -7366 4 19.4372 23.8368 18.5171 17.2732 8.77886 9.60074 -7367 4 20.7988 24.6336 18.2364 -23.7637 -10.2166 26.3276 -7368 6 16.5494 31.2838 16.4573 -15.9423 3.69088 33.2062 -7369 4 16.5519 32.1922 16.7594 11.1434 16.9832 -11.781 -7370 4 16.1476 30.8867 17.2522 1.55385 -15.8871 -15.2552 -7371 6 1.78983 14.6435 36.2904 4.99553 5.58283 2.2492 -7372 4 1.04893 14.2282 35.8708 -13.8588 -3.35469 -16.6141 -7373 4 1.66905 14.392 37.2023 2.39459 2.07051 19.2387 -7374 6 4.37166 29.2153 29.5914 5.79168 20.1405 -19.3585 -7375 4 4.91557 28.7254 30.2154 7.17051 0.117226 5.39869 -7376 4 4.91513 29.9512 29.1891 -14.7291 -26.607 12.32 -7377 6 43.6969 0.237019 22.6594 -7.19613 -4.49497 -5.57098 -7378 4 43.0237 0.783547 22.2316 -12.2242 -6.81623 2.03469 -7379 4 43.4415 41.2053 22.5454 5.15142 14.113 -1.35906 -7380 6 52.5052 40.9917 27.2414 -4.0762 -16.2903 -30.037 -7381 4 52.8129 40.7577 26.3208 -10.5132 10.5144 20.9332 -7382 4 53.295 41.2999 27.6882 6.37269 9.42971 1.77711 -7383 6 25.5785 23.9088 27.7352 -29.163 -0.147769 2.09076 -7384 4 24.7169 24.3904 27.6009 26.0068 -16.0483 4.45096 -7385 4 26.303 24.4711 27.4736 4.98376 5.99744 -3.44082 -7386 6 23.1322 17.0409 33.3147 -4.87562 4.34963 6.5261 -7387 4 23.1435 17.5188 34.1474 -0.665908 -2.26574 -1.07751 -7388 4 22.9237 16.1327 33.5379 -5.85649 -9.89669 4.05086 -7389 6 2.9235 11.8719 21.3628 -62.5775 -31.8178 -28.2901 -7390 4 2.1985 11.2347 21.6738 31.4392 30.9604 -16.9464 -7391 4 3.51176 11.9111 22.066 35.7266 4.49799 37.8533 -7392 6 2.17958 4.14491 30.0321 9.06251 -9.53771 -13.2585 -7393 4 2.15165 5.09682 30.107 -1.56529 16.7016 0.150815 -7394 4 2.7299 3.97467 29.2422 -7.5281 0.377543 4.10315 -7395 6 26.6694 30.2855 13.4776 10.1196 11.7228 27.7054 -7396 4 25.7357 30.4785 13.6549 -0.51692 -11.2356 -3.98914 -7397 4 27.0778 30.3597 14.373 -6.55394 -4.70072 -25.9179 -7398 6 24.8731 30.8123 10.8246 -35.9544 -8.06722 -7.65859 -7399 4 25.2097 30.0125 10.4324 5.41746 -9.73411 -7.41209 -7400 4 25.6149 31.228 11.1936 31.2673 18.7081 18.3938 -7401 6 53.1638 24.1184 4.51161 -10.4445 -35.9395 21.0824 -7402 4 53.5233 24.7957 3.98549 14.2054 30.1141 -21.0763 -7403 4 53.9237 23.6117 4.81383 2.71167 2.31883 7.09562 -7404 6 24.8958 4.51213 23.9931 -29.6363 -43.6073 15.3227 -7405 4 24.1339 5.1036 23.9039 18.5944 16.8193 -2.99678 -7406 4 25.7258 4.88904 23.7461 22.8138 27.5954 -9.18982 -7407 6 34.6838 1.65591 41.2514 12.8053 -23.083 -29.6978 -7408 4 35.6244 1.45761 41.0729 -14.4971 0.421146 -0.177754 -7409 4 34.7301 1.99199 0.211928 -2.47028 17.9107 34.9925 -7410 6 13.312 19.5249 16.387 18.9594 -19.3284 17.3248 -7411 4 13.9333 19.1674 15.7225 -9.24732 -4.9188 0.52103 -7412 4 13.2597 18.8166 17.0929 -3.23838 18.5958 -24.3952 -7413 6 48.698 0.181353 20.409 -0.21633 -26.9433 -24.4133 -7414 4 49.103 41.5184 19.698 -4.34753 24.5911 30.5043 -7415 4 48.7986 41.623 21.2469 8.80211 1.41451 -0.511645 -7416 6 43.0644 27.7916 11.5133 -14.5871 -6.12813 -9.0892 -7417 4 42.6 28.0105 10.6776 10.2055 -1.97818 11.3293 -7418 4 43.4908 28.591 11.8257 3.55806 4.66568 -1.20709 -7419 6 25.6909 21.365 35.1834 16.6334 21.4278 -26.2382 -7420 4 25.8486 22.0441 34.4664 -6.54449 -15.4554 28.1071 -7421 4 25.5413 20.5536 34.6727 -4.24699 7.33591 15.2905 -7422 6 44.7232 4.60607 27.7619 9.66663 0.618053 -4.25407 -7423 4 44.3234 4.00717 27.1079 -6.11804 2.34462 0.765623 -7424 4 44.3971 5.50639 27.5932 -3.06611 -6.30885 -0.545657 -7425 6 41.2897 11.4432 34.2066 -9.61739 21.0206 -8.56292 -7426 4 40.6842 11.5664 33.4581 3.14959 1.41378 -1.0752 -7427 4 41.1924 10.5195 34.3892 0.589219 -23.8889 7.33677 -7428 6 19.897 36.6492 2.04794 -32.5825 5.5481 -21.6378 -7429 4 20.6399 36.2361 2.4987 10.0826 10.558 0.716761 -7430 4 19.9026 37.6342 1.97212 14.9366 -15.8518 15.2433 -7431 6 27.4836 4.66736 6.35028 2.97665 -65.4375 -50.0742 -7432 4 27.6123 3.82169 6.79207 -3.46759 -4.72632 -9.32934 -7433 4 27.4741 5.24116 7.04108 -4.39889 64.7262 58.0755 -7434 6 16.8382 30.7844 39.9326 10.6925 -56.0648 15.7324 -7435 4 17.0186 31.2572 40.7403 -2.33579 15.7179 12.0581 -7436 4 17.0831 29.8382 40.1617 -5.04661 27.4351 -11.6424 -7437 6 51.1641 15.1933 16.3324 21.7581 16.0625 -9.079 -7438 4 51.121 16.0888 15.8936 10.5188 -25.5533 9.6052 -7439 4 52.0677 14.7794 16.1385 -37.3149 17.1399 3.28502 -7440 6 49.9904 21.2241 35.9744 20.9503 -33.7397 19.542 -7441 4 49.3714 21.5088 35.3291 -23.4605 10.1211 -23.8745 -7442 4 49.9121 20.2362 36.0002 2.40052 26.2853 0.00810801 -7443 6 34.428 0.14016 5.66944 -7.82493 37.3161 8.31948 -7444 4 34.304 0.843366 6.34479 2.68801 -11.9822 -16.4886 -7445 4 34.2591 0.582485 4.80419 9.04141 -16.6905 11.7821 -7446 6 48.3182 11.536 19.8764 -48.9228 13.3726 26.2823 -7447 4 47.7285 11.3649 20.663 34.2262 -2.74449 -19.9886 -7448 4 47.7235 12.1441 19.3775 23.4884 -14.873 -2.11476 -7449 6 4.19152 39.4305 13.3555 27.463 28.0369 44.5079 -7450 4 4.88401 39.7456 14.019 -21.6239 -15.7277 -33.754 -7451 4 3.37287 39.6897 13.8148 -3.76347 -10.7833 -11.4512 -7452 6 8.74995 16.191 8.53596 -5.05856 2.64204 -21.058 -7453 4 8.7323 16.8633 9.22906 0.669847 -0.203387 -6.91741 -7454 4 8.69158 16.6347 7.64451 3.76071 -7.46014 24.9197 -7455 6 29.0285 14.2822 26.5262 -5.84817 34.0816 17.5192 -7456 4 29.0044 15.2824 26.745 3.30971 -49.1818 -9.92417 -7457 4 28.1563 13.9159 26.7584 2.39554 12.59 0.416474 -7458 6 27.3852 14.5292 8.14264 -25.3608 8.37865 0.80053 -7459 4 26.4121 14.3996 8.08331 21.4517 0.6706 1.76752 -7460 4 27.495 15.4908 8.29449 3.73212 -17.2528 -1.50339 -7461 6 14.1265 27.2071 32.922 33.1666 19.82 -10.1122 -7462 4 14.9257 27.349 33.4618 -9.56175 -2.66902 -6.75133 -7463 4 13.49 26.8422 33.5082 -21.5238 -13.7689 15.9353 -7464 6 31.6534 35.7886 21.2701 -36.804 -37.663 0.546332 -7465 4 32.1208 36.3742 21.8378 9.4961 28.0075 13.3964 -7466 4 30.8651 35.4592 21.7961 25.8489 11.2411 -16.1565 -7467 6 54.2152 28.7064 16.8886 2.86275 11.2554 8.9719 -7468 4 53.522 28.534 16.2345 -0.160695 -4.94794 5.34414 -7469 4 54.0581 29.6054 17.2296 -4.68599 -7.1814 -6.41975 -7470 6 9.06113 5.28333 17.1437 22.8853 4.22723 -20.1716 -7471 4 9.91678 5.17464 16.6036 -37.1561 0.754494 23.2593 -7472 4 8.77829 6.22091 17.0709 7.89423 -13.2605 2.73354 -7473 6 29.6746 9.78112 26.5507 33.4729 -21.3737 16.6755 -7474 4 30.5187 9.26436 26.5785 -19.9088 14.0899 -1.39861 -7475 4 29.3838 9.79264 27.4752 -2.64272 0.36338 -0.771294 -7476 6 44.0224 31.1718 32.1785 -15.3292 -7.28341 -3.2168 -7477 4 43.2245 30.9732 32.7283 18.2556 6.42044 -7.39667 -7478 4 44.6106 31.7763 32.6435 0.791193 1.46174 13.5451 -7479 6 53.5017 3.62335 25.1421 -16.9806 -9.67341 -1.19546 -7480 4 54.1073 4.37139 25.2408 5.33888 -0.871569 -8.36925 -7481 4 53.4976 3.25444 24.2353 14.6771 10.8199 10.1585 -7482 6 12.4523 22.8699 3.37515 20.8696 32.0548 51.3092 -7483 4 12.8715 22.0381 3.24611 3.69599 -28.8916 -15.1378 -7484 4 11.7545 23.0169 2.77653 -28.9409 -2.61743 -32.5554 -7485 6 39.4163 29.6883 0.716973 23.965 14.7498 -4.51132 -7486 4 39.9876 29.0776 0.254063 1.0023 1.05593 -7.22278 -7487 4 38.7356 29.138 1.03498 -27.9991 -12.2746 11.9106 -7488 6 13.7523 37.8126 23.0391 19.0421 33.8918 15.0049 -7489 4 14.5819 38.1972 23.3968 -5.92503 -31.5844 -9.82397 -7490 4 13.2717 38.649 23.0641 -23.8611 -10.9328 -14.9892 -7491 6 33.3489 41.2294 0.00543 12.0778 19.0207 4.12226 -7492 4 33.8966 0.076279 41.545 -17.8654 -16.3366 26.9287 -7493 4 33.5442 41.0956 0.968664 -4.79835 4.63337 -24.688 -7494 6 15.7246 3.52046 6.32841 10.9162 -8.85937 41.3038 -7495 4 14.9211 3.23468 6.78447 -0.787572 2.77727 3.3355 -7496 4 15.4617 3.69817 5.45032 -11.5336 7.63209 -33.5323 -7497 6 27.7759 30.762 5.08277 5.52432 -34.0682 -16.3389 -7498 4 28.5998 30.6312 5.57248 -10.7862 7.58152 2.34054 -7499 4 27.6688 29.856 4.68367 -5.5152 22.3618 6.77689 -7500 6 13.3283 7.58248 23.3427 28.3072 -1.43357 14.0598 -7501 4 14.1858 7.86415 22.9596 -10.8574 -4.57961 9.77565 -7502 4 12.7328 7.50745 22.6198 -18.1881 0.025746 -17.8687 -7503 6 38.3062 37.3234 27.9933 -3.63803 -3.21002 47.0561 -7504 4 38.1692 37.3862 27.0673 7.32148 -0.46048 -39.7323 -7505 4 39.0245 36.7163 28.2248 2.26391 -1.88339 -8.27891 -7506 6 35.8197 12.5511 12.093 -4.81482 -18.6185 14.0356 -7507 4 35.6024 11.6096 12.0486 2.81432 1.21601 -0.921604 -7508 4 36.2712 12.7262 11.2865 10.3444 9.98072 -18.0035 -7509 6 52.1161 23.0926 41.2793 27.7225 -3.87143 -59.8556 -7510 4 52.4049 23.0393 40.2964 5.44511 3.0042 51.4604 -7511 4 51.1968 22.9093 41.149 -26.7248 -2.75497 17.7375 -7512 6 39.5495 11.6692 16.6079 -1.17202 -14.5197 -14.1262 -7513 4 39.7784 10.7494 16.7482 7.99576 -7.98247 -12.1867 -7514 4 39.4663 11.9292 17.5115 -4.38422 20.0879 20.6825 -7515 6 0.676885 9.01905 7.96736 13.1741 22.7352 -22.4375 -7516 4 54.8016 8.92404 8.29683 -40.226 7.08621 2.19233 -7517 4 1.10058 8.31451 8.38908 28.7575 -30.4684 16.9583 -7518 6 42.3311 28.7401 39.4661 13.4879 80.877 11.2525 -7519 4 41.6603 28.5849 40.0851 -34.7426 -11.2721 27.5092 -7520 4 42.5519 27.921 39.1558 20.2132 -66.4303 -37.3003 -7521 6 38.7411 30.2829 16.2738 12.7671 5.32399 18.4704 -7522 4 38.9183 29.8748 17.1496 -6.87016 4.31697 -11.6029 -7523 4 39.4059 31.0046 16.2472 -14.9795 -12.5163 -3.03567 -7524 6 7.58764 18.0405 0.648325 -47.6574 -19.7672 20.3632 -7525 4 7.12731 17.6217 1.42737 12.1211 9.19751 -27.5752 -7526 4 8.47251 18.0259 0.938181 42.7013 4.4664 8.86021 -7527 6 33.7296 34.5938 24.1405 -3.484 -2.51034 -8.30179 -7528 4 33.5251 35.3309 23.5532 1.13599 -1.72579 4.26838 -7529 4 33.8994 34.9649 25.0137 6.47563 -1.63099 1.09862 -7530 6 16.0166 40.0494 39.5956 -28.3908 0.329345 -1.37751 -7531 4 16.9382 40.2323 39.4336 17.0381 0.329941 -6.23981 -7532 4 15.5262 40.0524 38.7513 12.3223 -0.591958 2.13513 -7533 6 4.49229 37.1333 21.8385 27.3085 -52.2253 -58.5501 -7534 4 4.66683 37.716 22.5264 18.8147 38.5231 40.56 -7535 4 5.37915 36.8768 21.3985 -41.7208 12.465 14.7942 -7536 6 39.2691 20.1288 31.3316 -12.2203 -9.20146 -18.9279 -7537 4 39.1503 20.9416 31.8094 1.95478 16.2675 16.373 -7538 4 38.6746 20.1785 30.5607 4.99665 9.53371 7.24081 -7539 6 28.5508 6.16368 32.0494 2.8072 -5.52183 -6.01527 -7540 4 29.3622 6.49582 32.4253 9.65206 -4.8896 7.96618 -7541 4 28.0782 6.98121 31.874 -4.3704 -0.58129 1.95425 -7542 6 9.33595 11.3298 38.1871 -32.8874 9.84086 11.8913 -7543 4 8.64445 12.0594 38.2922 21.8008 -26.7714 -10.0524 -7544 4 8.88851 10.5546 37.784 7.69784 20.5749 -6.72048 -7545 6 41.6095 10.4782 6.86111 8.23897 -6.62675 34.9169 -7546 4 41.7694 10.1037 7.78655 -4.1265 15.4661 -32.721 -7547 4 41.7821 11.4382 6.90291 -3.49967 -11.9299 -5.09907 -7548 6 3.12867 28.1157 17.6206 15.6267 -45.6796 29.9202 -7549 4 2.63816 28.6493 17.0564 -29.7899 29.6493 -43.0934 -7550 4 3.59757 28.7421 18.155 7.53462 9.15161 11.5693 -7551 6 39.3499 12.2397 19.2529 -23.7838 14.9837 13.9357 -7552 4 39.2457 13.2286 19.3464 7.91877 -27.4185 3.68816 -7553 4 38.6075 11.8387 19.7677 15.6586 5.94778 -12.3856 -7554 6 2.78491 9.11686 31.712 -26.5503 -22.4732 34.9375 -7555 4 3.2978 8.41451 32.2045 -9.27186 19.8876 -17.5091 -7556 4 3.27525 9.5282 31.0263 27.6548 6.40843 -16.0242 -7557 6 47.0993 34.3062 24.1668 40.213 25.5871 3.96938 -7558 4 47.8652 34.9011 23.9742 -8.40565 -28.0457 9.8184 -7559 4 46.4391 34.8642 23.795 -37.1496 -1.08965 -6.28687 -7560 6 41.29 35.6184 9.54316 -30.0867 29.8286 7.21591 -7561 4 40.3249 35.7138 9.72984 17.4159 -14.0538 -3.31523 -7562 4 41.5907 36.542 9.70742 6.71087 -21.892 -10.0971 -7563 6 20.4656 31.4513 3.14505 -29.4444 2.15246 21.5865 -7564 4 20.9799 31.2087 3.9226 8.79014 -0.482357 -2.15716 -7565 4 19.5517 31.5947 3.51954 23.5031 -1.57475 -20.844 -7566 6 33.2192 17.965 24.7971 19.8065 25.0952 18.1835 -7567 4 34.1598 18.0267 25.093 -16.2559 -11.4614 -7.96855 -7568 4 32.9244 18.9016 24.8301 -6.14071 -21.8705 -2.46334 -7569 6 40.1545 39.892 35.7566 -26.4952 1.03865 35.1005 -7570 4 39.554 39.7115 35.0283 3.12548 3.08468 -2.58895 -7571 4 39.5538 40.0617 36.55 23.7339 -1.54775 -30.4418 -7572 6 4.86493 34.7165 16.5037 -1.18866 4.83191 -8.79653 -7573 4 4.98021 35.6639 16.3239 -2.48039 -7.07182 -3.79473 -7574 4 5.57973 34.27 16.0245 9.17482 -2.77359 5.31354 -7575 6 19.1203 11.0308 26.5475 4.8369 12.9311 -1.38474 -7576 4 19.2948 10.8261 25.6303 -10.7878 -2.53157 -9.81197 -7577 4 19.6222 10.3806 27.0285 -0.932765 -12.0852 11.9627 -7578 6 54.013 13.9266 34.7866 19.735 -12.4153 18.0126 -7579 4 53.1377 14.0488 35.1524 -10.4928 -1.09871 -13.0068 -7580 4 53.982 14.1469 33.8595 -3.66316 10.2302 -11.2602 -7581 6 1.83695 20.649 5.20524 25.5491 14.9074 -17.0883 -7582 4 1.35705 19.8566 4.90021 2.5306 9.60758 -2.11708 -7583 4 2.48138 20.9466 4.48633 -27.5057 -15.388 16.1855 -7584 6 22.2484 0.089789 14.2543 15.3573 -11.1234 0.0573231 -7585 4 21.4821 0.622149 14.4313 -9.66168 8.29964 10.305 -7586 4 22.7606 41.8363 15.0657 -14.7435 5.42194 -5.09127 -7587 6 4.9437 7.03924 24.7311 13.2528 -2.19763 7.32506 -7588 4 4.13251 7.3412 24.2993 4.98795 -3.92941 -4.4547 -7589 4 5.31694 6.26419 24.274 -9.7854 5.58222 5.45409 -7590 6 41.4768 20.8727 34.9433 -10.8141 32.3245 17.6117 -7591 4 42.0721 20.1596 35.0936 18.2074 -21.2429 -2.25611 -7592 4 41.5511 21.3995 35.7803 -3.93981 -14.5735 -18.4651 -7593 6 28.2063 1.73787 31.7361 2.56856 -6.63991 -21.6427 -7594 4 27.5833 1.04583 32.0206 5.931 11.5306 2.70007 -7595 4 28.427 2.28487 32.4907 -6.15569 2.19681 12.1249 -7596 6 16.8959 27.3728 36.9936 3.36683 -9.46076 -21.7251 -7597 4 17.1861 28.0765 36.4018 -0.835984 6.87178 9.62195 -7598 4 17.1491 26.5677 36.4964 -8.72142 5.45523 11.8618 -7599 6 26.8172 38.095 8.33253 -7.04389 15.4319 43.7153 -7600 4 26.4231 38.1886 9.22965 13.1827 16.4204 -18.9623 -7601 4 26.752 37.1697 8.26194 2.82704 -45.8494 -18.5449 -7602 6 26.6605 33.8021 23.2109 -14.7721 -8.40788 6.86704 -7603 4 27.1437 33.2455 22.6071 1.71839 -3.83047 -13.3917 -7604 4 27.3181 34.0928 23.8234 13.6598 11.6313 12.8928 -7605 6 10.2089 27.1103 30.2249 26.5091 -20.839 -19.8889 -7606 4 10.2296 28.0525 30.305 -4.35446 23.414 7.17464 -7607 4 10.909 26.9135 29.5485 -17.3927 5.996 19.4297 -7608 6 47.8678 12.6068 5.01236 10.3402 17.2727 14.3835 -7609 4 48.2471 13.4466 5.34357 -15.5974 -13.1618 -9.91905 -7610 4 48.2827 11.9587 5.58273 0.760146 -12.24 2.37579 -7611 6 53.3401 24.5564 22.1447 -33.4845 3.13007 15.4457 -7612 4 53.2868 24.6175 23.1082 -8.50106 -5.88574 1.47389 -7613 4 54.2491 24.6404 21.954 37.9576 4.9603 -12.0283 -7614 6 29.4115 10.751 19.3682 47.3718 16.1602 -3.46693 -7615 4 29.23 9.95501 18.9095 -1.62259 -22.6341 -18.5903 -7616 4 28.6164 10.8767 19.816 -47.8248 15.8998 30.722 -7617 6 39.4772 14.9486 19.552 50.4126 11.9025 42.2912 -7618 4 40.3976 15.2789 19.8627 -47.7598 -21.1435 -8.50237 -7619 4 39.4723 15.2512 18.6704 -12.4406 15.8155 -35.6919 -7620 6 32.8813 15.9868 22.8125 3.47488 17.0872 -31.9433 -7621 4 33.0166 16.4922 23.6113 -1.39335 7.20309 14.6349 -7622 4 32.7144 15.0846 23.0256 -4.37432 -22.045 19.0968 -7623 6 30.558 1.96704 21.5074 2.70654 -4.91402 -0.473851 -7624 4 30.6739 2.00523 22.4671 5.88049 3.20632 -1.97238 -7625 4 31.3728 1.59666 21.1136 -11.8747 6.17773 7.16567 -7626 6 0.976021 12.0022 3.31788 -2.33791 2.9975 -11.3542 -7627 4 1.23381 12.945 3.27167 -8.13702 -10.1344 5.41434 -7628 4 1.05317 11.6593 4.21576 7.83216 6.74936 8.77967 -7629 6 32.1417 30.4028 20.7928 -10.9162 7.90477 -12.8705 -7630 4 32.9583 30.6218 20.3315 4.32484 3.35409 -0.814586 -7631 4 31.4267 30.7883 20.2371 10.7836 -11.8724 10.7529 -7632 6 5.37233 35.5196 8.9984 1.65786 -0.655334 17.0686 -7633 4 5.15633 35.7733 8.10502 -8.52999 -6.98357 -10.434 -7634 4 4.86772 34.7263 9.2434 -1.9757 2.02155 -6.9424 -7635 6 49.9125 13.0387 32.1973 27.4626 15.6741 -16.8517 -7636 4 50.6053 12.9182 31.4733 -26.2683 -0.306922 26.3637 -7637 4 49.2504 12.3613 32.0764 -3.75185 -11.6573 -0.304044 -7638 6 4.31386 24.093 1.57868 7.45772 -24.8618 -14.5348 -7639 4 3.64218 24.7342 1.7864 -13.9986 8.43803 -2.25361 -7640 4 4.01488 23.4668 0.872394 2.3276 24.3041 16.4513 -7641 6 44.1644 38.1215 12.3455 -22.0907 -25.3739 20.9172 -7642 4 43.5152 37.5597 12.8481 16.1408 4.83783 -17.5332 -7643 4 43.8688 38.9961 12.5721 5.21907 21.319 -3.3764 -7644 6 44.6817 17.3326 22.8013 48.0619 -4.56356 -9.07637 -7645 4 45.2902 18.0584 23.1498 -22.5072 -22.7727 -5.21409 -7646 4 45.2932 16.6008 22.4593 -20.015 30.0459 19.1644 -7647 6 20.3678 11.7042 19.6638 18.1083 -41.9451 -24.672 -7648 4 19.8947 12.3606 20.1264 -14.0753 36.8205 14.9866 -7649 4 20.5011 12.0109 18.7433 -0.799123 0.72776 10.7716 -7650 6 4.45477 15.3976 36.1886 1.65809 1.26145 11.9226 -7651 4 5.09661 14.6681 36.098 -4.75494 5.61497 -10.92 -7652 4 3.56051 15.0123 36.2095 4.93474 0.57137 -3.51241 -7653 6 44.8032 39.5214 30.1736 10.2403 3.65831 -28.7798 -7654 4 44.6649 39.352 29.2044 0.893291 -3.4354 28.9244 -7655 4 44.1834 39.0261 30.7164 -9.9549 -0.503639 -4.51595 -7656 6 30.0776 3.52093 11.3186 -8.111 -9.63673 -5.93937 -7657 4 30.5797 4.33725 11.0789 -10.9699 -19.7375 -4.73534 -7658 4 29.9808 2.85663 10.5812 14.022 21.906 10.2093 -7659 6 25.6241 24.8658 16.1333 6.68449 -9.57605 -29.1286 -7660 4 26.5694 24.8046 15.8818 -8.72523 1.1772 17.1704 -7661 4 25.5267 25.1318 17.0381 12.8553 5.85519 26.3055 -7662 6 36.8177 29.8487 20.6561 -37.5479 -3.0004 33.0202 -7663 4 35.926 30.1959 20.4157 18.2985 -1.907 -0.407745 -7664 4 36.6716 29.3784 21.5423 12.7247 15.2026 -39.3319 -7665 6 52.2186 17.0658 38.3042 -7.89215 -38.4825 28.5148 -7666 4 51.4916 16.4675 38.6484 24.7832 21.5941 -14.95 -7667 4 51.8247 17.6139 37.6469 -10.8917 8.73986 -12.7264 -7668 6 3.82879 23.6249 29.8747 0.0111461 24.9347 -0.194649 -7669 4 4.57266 23.2964 29.3507 7.82142 7.55197 5.89536 -7670 4 4.12107 24.4472 30.3626 -2.93665 -31.334 -6.69289 -7671 6 6.37221 19.8955 41.0814 -10.7405 10.6187 0.232117 -7672 4 6.67124 19.2607 41.7286 9.67887 -12.4754 3.81392 -7673 4 6.49825 20.7419 41.4991 -1.14685 10.1205 10.9238 -7674 6 28.9128 38.9237 35.3305 22.4394 21.6131 25.3888 -7675 4 28.4594 38.2476 34.8641 -13.9867 -26.2755 -20.0992 -7676 4 29.711 38.4973 35.7105 -10.7836 3.83713 -8.57645 -7677 6 1.06675 30.3059 34.4729 25.4378 -4.31804 35.0042 -7678 4 0.780778 29.8064 33.7399 -5.76855 -22.7951 -38.2413 -7679 4 0.490797 31.0506 34.5199 -18.1513 16.5028 -0.872558 -7680 6 26.4359 22.0299 20.4363 32.8101 13.5123 0.44111 -7681 4 27.364 22.3315 20.3938 -13.8894 -16.1779 0.0777322 -7682 4 25.9647 22.8561 20.3336 -19.4369 -2.2953 -2.32927 -7683 6 3.94837 18.6341 22.6823 32.7056 -17.0211 23.8668 -7684 4 4.7768 18.6814 23.2391 -24.3494 -8.73456 -16.7413 -7685 4 3.72444 19.5457 22.6416 -13.4357 33.3979 -9.86072 -7686 6 6.89585 39.3162 26.9832 -46.5714 7.68979 7.72716 -7687 4 6.93923 40.0377 27.612 28.7888 3.33438 12.9127 -7688 4 5.92214 39.2413 27.0287 16.4173 -5.75108 -11.0421 -7689 6 43.9872 41.7521 26.5322 17.8857 -12.0416 -16.5154 -7690 4 43.9509 0.2718 27.3768 -8.40653 9.77536 19.5266 -7691 4 43.1315 41.809 26.1188 -22.0408 9.50446 -3.00799 -7692 6 31.7113 29.5746 16.987 -20.6637 1.93471 5.13032 -7693 4 31.02 28.863 17.0135 12.5534 15.6398 -7.64726 -7694 4 31.2508 30.4156 17.2234 10.2038 -24.3383 2.42367 -7695 6 46.2561 10.9612 15.5385 0.577538 -38.7584 22.3134 -7696 4 45.3251 10.7213 15.4484 -5.02058 7.03855 -0.171485 -7697 4 46.6569 10.0824 15.7727 -2.20865 28.2857 -11.3723 -7698 6 36.5827 15.0435 25.8168 31.2067 4.61936 9.12499 -7699 4 37.3875 15.5118 26.1911 -33.209 -18.98 -14.6655 -7700 4 36.1295 14.6889 26.5897 -4.0863 -6.05063 3.58839 -7701 6 47.2722 22.6647 6.13576 -8.17133 27.0247 -35.749 -7702 4 46.6204 23.3224 5.77393 14.8224 -22.4366 13.8178 -7703 4 46.9842 22.4705 7.01441 -4.98592 -2.25738 16.061 -7704 6 27.5378 39.6651 17.8024 -2.94112 10.9701 -10.3343 -7705 4 26.5953 39.7232 17.618 -8.53785 1.10642 -8.0722 -7706 4 27.5664 39.1005 18.5557 5.38052 -12.9364 18.2146 -7707 6 14.0357 27.9675 36.8848 11.7171 -39.9071 2.25396 -7708 4 13.4367 27.1833 36.8225 11.7441 28.4062 -4.63591 -7709 4 14.9372 27.5486 36.8957 -17.1932 18.8386 1.76957 -7710 6 33.7684 13.0304 13.8649 26.1794 -24.2655 -33.187 -7711 4 34.6252 12.938 13.363 -28.3858 22.7045 20.1179 -7712 4 33.4338 12.1329 13.7478 -6.61414 4.24237 14.4002 -7713 6 3.3826 17.477 1.97134 -12.4208 -32.1468 -36.6933 -7714 4 2.99872 16.7111 1.40376 19.9781 39.313 29.0042 -7715 4 3.44044 18.2025 1.33186 0.336883 0.1642 8.16047 -7716 6 27.5407 2.76347 36.4361 37.1152 10.6125 -5.75272 -7717 4 28.1274 2.95293 35.6781 -8.18971 -2.06925 12.0999 -7718 4 26.7696 2.41682 36.0063 -15.232 -6.73967 7.66134 -7719 6 21.3092 1.20818 18.7198 27.6808 -56.7894 17.4302 -7720 4 20.9088 2.03925 18.6129 -17.8717 42.912 1.2548 -7721 4 21.1846 0.863131 19.6413 -10.5106 12.8119 -18.3621 -7722 6 11.8887 16.6751 29.3062 -13.3787 -14.7829 9.57092 -7723 4 10.9992 16.5416 28.8882 19.0949 3.10928 11.6713 -7724 4 11.8781 16.1991 30.1864 -3.15773 18.3703 -25.9576 -7725 6 15.9606 29.4505 29.6321 19.1231 40.0535 19.8704 -7726 4 16.8787 29.2659 29.409 -1.79459 -0.812108 -5.15406 -7727 4 16.0576 30.3074 30.1528 -10.887 -31.0851 -11.0284 -7728 6 42.9296 7.03459 4.51333 33.3286 4.63812 8.33203 -7729 4 43.4321 7.52085 3.82302 -14.3213 -8.56549 9.51251 -7730 4 43.6462 6.74019 5.1384 -26.8219 -5.28882 -15.1101 -7731 6 46.4281 26.3352 18.5118 -29.5226 20.9834 -10.3716 -7732 4 46.6343 27.1839 18.9751 -0.829481 -30.2492 -9.82569 -7733 4 45.6684 26.5824 17.9287 20.9241 -8.5113 7.46212 -7734 6 26.8394 31.9326 30.1088 25.5924 -16.6135 -32.4851 -7735 4 27.2107 31.0232 29.8435 -20.3392 35.4128 12.4615 -7736 4 26.6802 32.4017 29.2373 1.48159 -21.8349 29.7067 -7737 6 19.4878 37.6142 31.2562 -14.4543 3.58951 24.8148 -7738 4 19.156 36.8698 30.7235 -3.28844 3.66685 11.8368 -7739 4 19.1019 37.6358 32.1884 8.87174 -10.6544 -29.6345 -7740 6 52.3726 32.7139 12.8078 14.0751 37.5782 -32.6023 -7741 4 51.9367 33.0602 12.0031 -5.44932 -19.1877 9.81768 -7742 4 53.2329 33.1776 12.7347 -13.6236 -17.9256 14.0183 -7743 6 6.74161 9.28353 24.0307 -13.1667 -36.0519 9.75632 -7744 4 6.38029 9.61276 23.1997 0.718458 -3.76261 -6.90188 -7745 4 6.16941 8.51095 24.2946 11.6474 19.2019 -8.42102 -7746 6 39.7455 39.5612 25.4988 -8.346 1.54154 -0.59194 -7747 4 39.7035 38.6168 25.2826 0.975023 6.38379 0.651723 -7748 4 38.8484 39.7767 25.8082 2.0142 -6.85885 -0.770105 -7749 6 24.0762 14.0053 21.1456 13.3165 -18.5501 -35.6859 -7750 4 23.5798 13.5675 21.8237 -9.9014 -1.44375 19.5869 -7751 4 24.3047 13.2647 20.5221 -3.72657 29.1491 15.9401 -7752 6 5.19759 41.7876 24.8616 10.5329 -30.3401 13.9713 -7753 4 5.96107 0.070496 25.4117 5.01198 -1.48177 -8.04364 -7754 4 4.80364 0.70791 24.6471 -6.87058 19.426 -10.6286 -7755 6 42.3635 20.8692 21.2747 32.7502 -34.6644 -10.1673 -7756 4 42.4242 20.4785 22.1458 -3.583 2.66194 10.2144 -7757 4 41.7418 21.5604 21.318 -29.6652 28.4695 2.24145 -7758 6 48.2477 15.3659 33.5923 1.80889 -1.28345 12.5443 -7759 4 48.6164 14.6993 32.9992 0.330488 0.612282 -4.05403 -7760 4 47.6342 15.9182 33.1009 -4.13716 0.340872 -13.8372 -7761 6 46.021 38.2915 16.5867 23.3569 13.4435 24.034 -7762 4 46.6714 37.7063 17.0526 -15.1447 15.3639 -15.4724 -7763 4 46.2171 39.2064 16.9307 -10.1858 -20.2136 -16.2853 -7764 6 4.64649 28.484 21.3661 -49.4423 -36.8464 -34.122 -7765 4 5.0061 28.857 22.1388 17.5694 9.2675 37.6073 -7766 4 4.11403 27.6656 21.6036 24.8595 24.6655 -3.1651 -7767 6 20.5601 15.1658 18.389 17.6685 -18.4833 12.4376 -7768 4 20.0269 15.9148 18.1339 -10.4277 9.01273 0.992097 -7769 4 20.1375 14.696 19.1318 -1.87864 11.9594 -2.12399 -7770 6 16.2536 13.648 17.4664 -31.6255 -3.12789 -19.3987 -7771 4 16.1444 14.6075 17.6118 2.65347 -13.1818 -8.15029 -7772 4 15.6032 13.3943 16.7283 22.0135 11.6863 31.5082 -7773 6 52.4969 30.9511 18.1582 10.5176 -22.8935 27.2955 -7774 4 52.1187 31.5845 17.5724 -17.5669 13.4893 -21.7562 -7775 4 51.7599 30.5669 18.6706 14.518 10.6779 -8.97027 -7776 6 24.417 1.73185 15.7818 -6.46311 -4.24469 33.4298 -7777 4 24.2563 1.19981 16.5985 3.98325 2.24538 -18.7421 -7778 4 24.1038 2.61269 16.0335 4.13298 0.832539 -9.96215 -7779 6 23.8696 5.09384 31.0808 18.8621 -40.8234 -26.8653 -7780 4 23.8491 5.89936 31.5593 0.144588 30.2314 14.3891 -7781 4 24.8063 4.82715 30.9043 -17.3015 12.7186 6.18451 -7782 6 29.664 30.9246 0.393748 19.8337 -4.81556 23.0674 -7783 4 30.503 30.586 0.018652 -21.3617 6.75777 -1.54054 -7784 4 29.144 31.3327 41.6109 -5.17979 -0.628515 -14.2195 -7785 6 32.8496 37.8945 22.5158 10.0753 4.77658 10.1953 -7786 4 33.692 38.178 22.1563 2.67507 -3.41774 -7.7275 -7787 4 32.953 38.1222 23.4459 -10.6691 2.21895 5.00606 -7788 6 16.4801 17.3789 33.7607 -9.23434 -4.14589 -23.771 -7789 4 15.9446 17.8653 33.093 7.5539 3.01496 23.5583 -7790 4 17.136 16.9338 33.2029 1.0053 3.7812 3.66748 -7791 6 9.22576 13.3955 27.544 21.8484 -6.91303 -4.28818 -7792 4 8.36976 13.4851 27.1157 -15.2219 0.444174 10.4645 -7793 4 9.14931 12.9772 28.4181 -9.36318 7.36421 3.71477 -7794 6 43.4776 7.7356 17.2334 -9.59035 3.82748 19.1182 -7795 4 43.4092 7.74545 18.2218 0.501649 1.62452 -33.0026 -7796 4 44.4173 7.85634 17.0579 0.99974 -1.57098 -4.99047 -7797 6 22.314 24.3423 23.1668 -12.6246 5.51695 -1.93377 -7798 4 22.7955 23.5193 23.2443 6.83464 -10.1031 3.26418 -7799 4 21.5276 24.1384 22.6266 3.35813 5.31764 3.82921 -7800 6 26.0086 32.9187 32.7195 -0.756619 6.65713 -1.20686 -7801 4 26.2515 32.7095 31.8047 -0.82286 -4.52018 -0.557583 -7802 4 25.2078 32.4163 32.9092 -2.81033 -0.378904 -0.617388 -7803 6 16.9305 19.0463 7.44765 14.0068 18.7364 -6.96389 -7804 4 16.3855 19.2981 8.21028 -2.47769 1.30563 -6.88861 -7805 4 17.0815 19.8512 6.87677 -9.59141 -23.4241 18.196 -7806 6 48.1118 14.458 27.5672 -1.70385 5.14823 10.3583 -7807 4 48.0423 15.1786 26.9235 1.90686 -4.78611 -1.19899 -7808 4 48.0875 14.8765 28.4507 4.89589 -0.740891 -11.823 -7809 6 52.3863 41.7399 11.1185 2.41988 14.2085 23.7397 -7810 4 52.3863 0.193993 10.2459 -4.45976 10.8931 -22.0542 -7811 4 52.6887 0.557857 11.7005 -5.56281 -10.4239 -7.84704 -7812 6 36.3311 6.93589 12.7094 -2.38398 9.53491 -1.97617 -7813 4 36.3789 7.90344 12.827 -2.48918 -10.7733 3.15906 -7814 4 37.2588 6.6822 12.6726 5.22435 -7.00461 -0.877062 -7815 6 8.24215 20.3216 16.6719 4.98767 -5.10439 -5.65687 -7816 4 8.08588 19.3952 16.4038 -4.3079 5.82994 10.8424 -7817 4 9.2046 20.4438 16.7199 -1.30961 -3.63404 -4.19262 -7818 6 28.7954 40.3113 12.828 -13.6179 6.23593 21.4452 -7819 4 29.5192 40.3706 12.2287 20.8327 -7.3113 -16.8089 -7820 4 28.5554 39.3777 12.9053 -3.26344 4.60902 -2.65931 -7821 6 18.1473 11.8343 16.9395 -0.80483 -16.2761 12.6256 -7822 4 17.6848 12.6388 17.2294 4.62203 -2.59462 -3.9508 -7823 4 19.0947 11.9922 16.9221 7.13726 16.095 1.27241 -7824 6 30.8869 17.4142 21.504 -52.7305 12.2285 -31.3088 -7825 4 30.1482 16.8222 21.1884 27.1221 10.2955 22.0665 -7826 4 31.6253 16.8731 21.7262 19.9221 -18.6281 13.9623 -7827 6 34.8012 19.4194 37.9626 16.1869 22.0253 -15.6613 -7828 4 34.8979 20.1386 37.2822 -2.41662 -18.1877 20.3873 -7829 4 34.2105 18.7604 37.6043 -6.15487 -8.04615 -10.7113 -7830 6 35.8208 16.8923 29.2032 22.3367 20.7443 33.8648 -7831 4 36.613 16.5252 29.6466 -9.20578 0.119567 -6.22754 -7832 4 35.5382 16.2441 28.5922 -11.4717 -30.451 -21.7041 -7833 6 3.04279 32.2854 6.33929 -26.9238 12.3825 -4.69033 -7834 4 2.12647 32.146 6.0594 1.42689 6.59766 6.64942 -7835 4 3.42261 31.4611 6.08203 25.9982 -20.506 -0.598367 -7836 6 26.7966 41.6596 10.1464 32.6739 -10.8326 9.81865 -7837 4 27.6955 41.4226 9.79016 -25.5431 4.71255 4.81996 -7838 4 26.9918 0.01593 11.0584 -5.4334 2.64263 -3.14356 -7839 6 52.266 24.562 24.8685 -9.42886 0.421982 -6.72882 -7840 4 51.3046 24.7615 24.9057 17.7877 -5.82089 5.23086 -7841 4 52.6568 24.8699 25.6923 -4.67896 5.24225 9.60646 -7842 6 22.6938 22.6511 33.5751 -3.71591 7.58927 38.5179 -7843 4 23.2073 23.1628 34.2375 -1.81825 -3.74423 -24.5931 -7844 4 21.9227 22.4274 34.1227 -1.3969 -6.37714 -14.1968 -7845 6 10.6508 14.2453 33.0462 38.3111 -19.1724 1.31243 -7846 4 10.5904 14.9583 32.4175 -11.7628 10.624 -9.61146 -7847 4 9.79743 14.0525 33.3881 -28.4056 0.15536 2.16046 -7848 6 21.8963 10.8464 11.5207 26.0054 2.65771 10.2946 -7849 4 22.8204 10.615 11.7238 1.04479 5.32162 -7.74354 -7850 4 21.5123 10.8483 12.397 -14.7134 -4.5627 10.8449 -7851 6 38.3602 6.02493 25.8481 -1.65407 -6.16467 0.326828 -7852 4 38.011 6.16356 26.7557 4.19059 11.4538 -13.8011 -7853 4 38.4332 6.8537 25.3449 -2.0709 2.94932 12.5244 -7854 6 30.9335 26.6426 38.5759 12.2579 -6.52521 -50.146 -7855 4 30.9725 26.4832 39.4983 -1.12433 -12.3748 34.5417 -7856 4 31.1634 25.7976 38.1184 -10.2303 12.0451 18.6771 -7857 6 30.1758 14.6176 35.4883 -28.0954 45.5198 -22.6945 -7858 4 30.377 15.4621 34.9933 16.3957 -28.3235 8.82257 -7859 4 29.2055 14.6893 35.4544 11.1506 -16.8188 10.9927 -7860 6 12.5393 37.2199 16.9523 -39.8589 -5.36999 -7.27655 -7861 4 12.8749 37.9509 17.4338 22.3846 22.4284 20.6781 -7862 4 13.1653 36.5135 16.9845 23.2041 -13.3789 -0.375674 -7863 6 27.4265 21.5607 37.7225 20.8747 -12.9562 -0.181201 -7864 4 26.9326 21.725 36.9211 -12.0211 3.79264 -7.84561 -7865 4 27.0206 21.994 38.4656 -12.5008 8.35973 2.85409 -7866 6 29.6119 18.3909 12.6766 5.02953 -16.5769 27.1188 -7867 4 29.5217 18.1084 13.6179 -1.01954 6.11509 -19.9302 -7868 4 28.7057 18.4542 12.3734 -9.03627 4.70036 -1.08008 -7869 6 2.35849 15.6559 0.172343 -13.1317 26.5324 40.4931 -7870 4 1.57628 15.538 41.5798 -33.9312 2.46749 -10.4392 -7871 4 2.94928 15.1153 41.6306 46.9044 -35.3027 -23.6199 -7872 6 17.8239 25.728 4.21905 -37.6117 -8.49993 -31.7596 -7873 4 16.8718 25.6243 3.8952 33.4499 1.9374 22.526 -7874 4 18.2969 25.7387 3.3671 7.88894 5.9968 18.5236 -7875 6 41.8048 11.1855 20.2736 -2.74436 -4.31591 -6.39865 -7876 4 42.499 11.3266 19.6063 -2.31748 -7.213 6.47037 -7877 4 40.9812 11.3277 19.7997 -4.16553 7.78699 0.129723 -7878 6 38.0436 18.3822 24.0291 -8.03771 -8.75406 0.916934 -7879 4 38.3881 19.1147 24.5363 7.93091 8.32946 7.65245 -7880 4 37.8775 18.7197 23.1534 1.15748 3.59885 -9.88254 -7881 6 4.13949 13.9245 33.751 32.8429 -54.5446 -5.73928 -7882 4 3.27676 13.674 34.0388 -19.3763 3.63281 4.9893 -7883 4 4.61955 13.0097 33.6871 -20.752 50.0513 -2.76975 -7884 6 19.1955 19.1942 26.4999 -2.68794 -13.6734 16.0889 -7885 4 19.5301 20.0447 26.2113 2.49975 9.05121 -5.4902 -7886 4 18.8802 18.7176 25.7363 0.91839 -0.338605 -10.966 -7887 6 22.4654 26.212 25.3377 -43.9819 -31.3945 15.8492 -7888 4 22.341 25.462 24.7348 6.987 2.92742 -4.90062 -7889 4 23.2684 26.6111 25.1223 47.0594 15.091 -19.0516 -7890 6 48.8212 32.07 32.5598 -32.6217 13.0764 9.49579 -7891 4 48.8519 31.1339 32.3903 9.77015 -16.5586 -2.94571 -7892 4 49.6142 32.4858 32.2593 19.8009 3.1546 -7.06015 -7893 6 25.2092 18.0177 27.0119 4.84672 -18.7822 -3.15467 -7894 4 24.5216 17.4674 27.4199 2.41306 12.0417 3.55819 -7895 4 25.6695 17.4202 26.3966 -2.25094 9.61905 1.21472 -7896 6 1.75029 41.5558 24.9373 10.8929 -9.66126 -16.5331 -7897 4 1.94143 40.8029 24.3062 -11.1729 27.8661 22.017 -7898 4 1.33214 0.330238 24.3814 7.15774 -16.2959 10.6574 -7899 6 18.6827 11.7655 10.8523 -12.8723 -21.6642 16.1997 -7900 4 19.5636 11.9042 10.4948 -5.12175 -0.337419 -4.96303 -7901 4 18.6779 10.8452 11.2231 -2.76434 23.9208 -10.2934 -7902 6 45.6216 16.5622 4.85345 35.2391 7.72621 -8.96994 -7903 4 46.5826 16.2921 4.84248 -29.2944 1.01327 2.32041 -7904 4 45.6571 17.5026 4.56372 -8.00263 -16.2723 6.75488 -7905 6 40.6693 36.3938 24.0175 15.8353 8.34465 -33.37 -7906 4 40.8833 36.7626 23.1096 -14.2319 -6.57786 31.0793 -7907 4 40.765 35.4388 23.9669 -2.25062 -4.28397 3.06966 -7908 6 32.2103 36.323 4.961 11.3673 -15.0032 -27.5021 -7909 4 31.6022 36.0041 4.27996 -13.8963 14.3234 5.17466 -7910 4 32.9864 35.7931 4.73143 4.05858 7.46319 17.1387 -7911 6 1.60869 14.6755 10.8061 -10.0389 6.06769 39.8197 -7912 4 2.33356 15.3221 10.9109 -7.21973 -7.23845 -0.707439 -7913 4 1.19104 14.6475 11.7231 10.7485 2.93157 -30.114 -7914 6 35.0001 14.2727 28.079 63.2852 10.3217 34.449 -7915 4 34.8812 14.1453 29.0533 -4.19424 -2.10072 -23.3494 -7916 4 34.1798 14.2655 27.6589 -51.5469 -5.32036 -14.2309 -7917 6 54.7125 6.11605 21.8555 -14.0361 -8.25377 2.86163 -7918 4 53.7845 6.02557 22.1597 12.8111 1.82594 -4.22103 -7919 4 0.03027 6.89073 22.319 4.64766 10.0402 5.34703 -7920 6 31.7713 16.925 27.3783 -6.86907 -7.88471 17.2493 -7921 4 30.8352 17.1376 27.29 -7.38275 1.84485 -8.02972 -7922 4 32.1916 17.1776 26.567 8.49209 11.7792 -21.4891 -7923 6 14.465 28.0197 11.093 -4.59026 -39.5121 13.6529 -7924 4 14.1257 28.8224 11.4501 -8.46011 24.0779 0.0563038 -7925 4 14.7692 28.1802 10.1981 4.52198 5.50754 -5.24146 -7926 6 35.6475 19.4845 18.3155 9.57103 -1.809 -3.39748 -7927 4 36.1727 19.3545 19.1113 -4.74674 6.51425 2.74698 -7928 4 35.0476 18.7267 18.3208 -0.78661 10.9943 -3.1182 -7929 6 0.909574 12.7326 15.4512 -4.00403 -44.3255 -0.361194 -7930 4 0.713888 11.7498 15.2844 2.79491 38.2978 9.54583 -7931 4 1.42535 12.7402 16.2831 -6.10996 -1.10113 -5.97882 -7932 6 52.7151 14.8297 20.9852 -8.18072 -78.4028 12.8764 -7933 4 52.2089 13.9625 20.7908 19.9141 35.1606 18.4317 -7934 4 52.3599 15.4219 20.3591 -8.09633 28.1752 -16.3986 -7935 6 7.5074 6.79303 13.6094 20.1749 -33.1825 -2.20484 -7936 4 7.51894 7.72815 13.8132 13.5555 7.5777 -3.02343 -7937 4 8.44355 6.42469 13.5879 -32.5694 21.0012 0.325521 -7938 6 12.8707 29.146 30.9458 -23.5578 15.3335 -40.981 -7939 4 12.9428 28.445 30.3111 -4.06483 -0.044806 -18.3112 -7940 4 13.2276 28.7127 31.6654 25.7046 -17.9249 62.7325 -7941 6 8.91318 29.991 35.6703 -0.0610651 3.14803 31.5119 -7942 4 8.887 30.0597 36.6571 13.1627 -14.4278 -23.4692 -7943 4 8.81345 30.9051 35.4106 0.983205 7.41015 -17.1111 -7944 6 29.2436 7.20633 5.57892 -54.0378 33.243 -15.4453 -7945 4 29.9077 6.6209 5.82325 37.3203 -38.0996 12.3519 -7946 4 28.4255 6.92245 6.05186 24.5111 10.6259 -6.90283 -7947 6 25.8948 9.2579 3.86177 -16.7921 -19.1399 -16.9328 -7948 4 26.6486 8.78935 3.46547 3.6066 2.83982 9.7025 -7949 4 25.146 8.75694 3.47524 9.6908 8.1243 10.3781 -7950 6 46.1591 19.5353 23.8511 81.1089 -3.44953 5.31324 -7951 4 47.0572 19.4192 24.3423 -46.5837 0.334518 -9.80273 -7952 4 46.5432 19.8542 23.0066 -21.4105 0.836057 1.37554 -7953 6 18.5926 35.3225 28.784 52.2521 -24.0621 1.05868 -7954 4 18.6271 36.1437 28.292 -9.91963 10.3291 -8.20284 -7955 4 19.5499 34.9756 28.7398 -42.866 14.0686 4.10052 -7956 6 27.9863 22.6413 32.202 21.6529 -11.7193 -18.2399 -7957 4 28.0891 22.9783 31.3009 1.03266 3.02954 6.56078 -7958 4 27.1414 22.9613 32.5068 -4.28354 -0.549074 4.96673 -7959 6 25.9903 18.4326 22.6797 -22.9747 -15.6034 11.3844 -7960 4 26.7869 18.8273 22.3692 24.9379 13.7229 -5.91644 -7961 4 25.7208 18.921 23.4832 11.724 -6.94511 -8.75168 -7962 6 31.1697 23.092 29.1693 -11.9745 -15.1316 21.2053 -7963 4 31.2077 22.141 28.9533 -3.34012 7.58841 -3.35467 -7964 4 31.7416 23.575 28.5808 9.8436 3.86516 -11.5721 -7965 6 36.6303 4.93142 0.48008 48.3 12.3871 -22.3067 -7966 4 36.6637 5.82298 0.895967 -3.77214 -15.5899 -6.86281 -7967 4 37.4556 4.91994 41.7793 -42.6939 0.501904 23.801 -7968 6 36.4828 20.995 10.0445 1.4409 16.9025 7.88029 -7969 4 36.442 20.1354 9.60774 -3.67605 2.90774 1.0232 -7970 4 35.8889 20.9899 10.8082 0.675338 -5.55749 -3.21659 -7971 6 50.6068 25.1826 18.3885 -34.0155 8.99756 4.28297 -7972 4 49.9165 24.7513 17.8483 3.12051 4.84127 10.9758 -7973 4 51.4426 24.9479 18.0312 23.0155 -7.64449 -5.94589 -7974 6 50.1857 39.6546 12.4249 -35.8487 -4.75972 18.1961 -7975 4 49.7435 38.8097 12.6589 9.38526 12.3917 -5.89531 -7976 4 51.0761 39.4561 12.2056 25.3285 -5.23538 -8.69122 -7977 6 30.5392 12.4112 4.81308 -24.6918 -8.37115 23.8709 -7978 4 30.0105 11.5821 4.90198 12.5687 16.0288 7.14 -7979 4 30.9611 12.2897 3.99028 20.9425 -4.88336 -30.4106 -7980 6 28.9507 15.4785 21.8764 2.88494 -37.77 16.9414 -7981 4 29.2026 14.5932 22.3105 -13.0637 39.016 -13.1967 -7982 4 28.2142 15.8194 22.4189 7.40001 -5.36107 -10.8423 -7983 6 14.0621 9.56364 16.9937 6.86557 -12.9325 3.68967 -7984 4 14.7638 8.91135 17.1437 -0.397896 3.39204 -3.97785 -7985 4 14.5001 10.412 17.0773 -1.84745 7.98018 -3.95086 -7986 6 4.48418 30.1793 11.8502 16.4679 -16.8356 33.0547 -7987 4 4.88144 29.8061 12.6848 -7.18701 8.62616 -23.9784 -7988 4 3.54784 30.2411 12.0492 -7.30801 4.11375 -9.31782 -7989 6 40.8925 8.06286 23.6531 -5.33465 -0.617655 -7.49645 -7990 4 40.8929 8.28602 22.6923 5.67883 -10.477 13.1878 -7991 4 40.7177 7.10184 23.7416 4.86142 9.55736 -10.8624 -7992 6 53.7474 35.0502 16.7091 9.64852 13.8526 -34.5004 -7993 4 53.4511 35.8404 17.1588 -1.68768 2.98716 11.3576 -7994 4 54.0332 35.3898 15.821 -5.01984 -16.258 24.672 -7995 6 53.7089 10.1864 20.3635 2.29909 -3.91508 11.8946 -7996 4 53.865 9.95358 19.435 -6.30341 10.2468 0.803923 -7997 4 53.074 10.9174 20.4153 4.1525 1.61451 -13.3956 -7998 6 4.58325 27.0727 7.79253 38.2121 26.3993 -10.0836 -7999 4 5.27724 26.393 7.80253 -10.2172 -9.80276 1.23658 -8000 4 3.71677 26.7514 7.92113 -24.69 -25.9094 6.50141 -8001 6 50.5074 22.5408 22.1421 -8.69376 -16.3879 19.9073 -8002 4 50.2488 23.2402 22.7623 5.11604 2.17524 -13.9015 -8003 4 50.7961 22.8564 21.2903 3.5618 14.8025 -7.32432 -8004 6 7.04732 27.2027 21.6256 -40.8926 -21.8944 23.9514 -8005 4 6.7035 26.7027 22.422 28.3929 12.8045 -18.4773 -8006 4 6.19014 27.4064 21.2095 22.0893 5.82121 -6.88916 -8007 6 23.8331 35.0488 16.5891 16.32 14.4309 46.4508 -8008 4 24.6955 34.7392 16.9507 -15.4311 10.68 -10.0146 -8009 4 23.6772 34.608 15.7848 -0.180345 -20.5093 -35.2233 -8010 6 5.99568 23.9111 3.91414 -16.1284 -13.3557 2.33299 -8011 4 5.47632 24.0272 3.08057 3.14343 -7.41418 20.837 -8012 4 5.41258 23.5631 4.6401 5.53308 9.77645 -18.8553 -8013 6 38.7285 25.0725 19.1284 6.5843 12.292 11.4002 -8014 4 38.8305 24.3279 18.5317 -0.433768 -14.0645 -4.65001 -8015 4 38.9527 24.8378 20.0476 4.74577 -1.1864 -10.184 -8016 6 12.9754 18.2903 10.6176 0.588158 -4.74371 -11.7219 -8017 4 12.1189 18.2831 10.1754 -4.50324 1.27903 -1.36841 -8018 4 12.8026 18.5801 11.5112 2.24696 5.46905 14.7352 -8019 6 38.0467 41.2366 21.1082 -14.4892 -16.6352 -5.66336 -8020 4 37.1721 40.8226 21.1941 10.2151 -2.13153 3.70269 -8021 4 37.8745 0.133442 20.6393 0.730193 23.6843 -6.95691 -8022 6 6.9767 22.8602 17.8447 -15.6268 -18.8158 0.81989 -8023 4 7.5707 23.5707 17.6602 21.732 18.7089 -7.75629 -8024 4 7.31556 22.0497 17.428 2.05587 4.83625 4.35773 -8025 6 24.1095 19.3932 12.3316 12.1602 -2.11517 -13.1018 -8026 4 23.8745 19.734 13.1953 2.64822 12.0925 0.881714 -8027 4 23.8476 18.4865 12.3899 -10.6841 -23.2361 -5.46211 -8028 6 44.2232 28.4408 4.82746 -1.7669 2.66578 -25.5607 -8029 4 44.2803 28.1144 3.91045 1.22274 -3.80694 10.7546 -8030 4 44.1446 29.3994 4.68927 4.81937 -0.158515 8.55 -8031 6 23.3113 8.29915 21.4219 -9.51684 27.1403 7.66167 -8032 4 22.936 9.22921 21.4746 15.7805 -27.4461 5.90598 -8033 4 23.1012 8.0569 20.5135 3.89809 -6.65443 -0.402871 -8034 6 14.3464 2.18773 18.5362 -23.516 16.4481 4.67993 -8035 4 14.2678 1.24418 18.6898 10.1474 -10.2606 4.48578 -8036 4 15.2445 2.40605 18.3047 18.9771 -8.71598 -6.68368 -8037 6 28.0424 31.9381 34.1184 1.44373 -10.4149 10.0158 -8038 4 28.467 32.321 34.8914 3.92062 5.65333 3.09761 -8039 4 27.2701 32.5111 33.9835 5.51879 -6.95928 -12.9635 -8040 6 53.345 24.6925 18.2818 -10.4918 -25.9433 -31.7967 -8041 4 53.4866 24.6975 17.3285 -0.882305 -10.6531 -2.1422 -8042 4 53.7306 25.5021 18.5264 15.118 39.739 24.3772 -8043 6 36.8049 28.4285 22.9464 16.1639 5.31016 -1.79263 -8044 4 36.683 28.9472 23.7552 -13.3671 -7.69746 -0.238436 -8045 4 36.1639 27.7179 22.9267 -11.0056 -9.60672 10.1241 -8046 6 21.894 30.586 27.4834 -30.837 -7.47848 12.2714 -8047 4 22.1658 31.0121 28.3029 9.93408 7.2142 -4.82479 -8048 4 22.5499 30.6966 26.8178 23.3081 1.01511 -13.2982 -8049 6 10.2866 3.2829 27.2371 9.19947 -3.548 -7.92128 -8050 4 10.1566 2.73648 28.0281 -11.5907 7.20828 -5.58516 -8051 4 9.50383 3.79492 26.9844 -8.05462 -4.00143 11.7964 -8052 6 37.7145 25.01 29.7057 15.6828 -51.4836 -24.4954 -8053 4 38.34 24.5625 29.0621 -16.831 21.3675 19.2093 -8054 4 37.2613 24.2159 30.07 -2.41186 22.6264 5.87672 -8055 6 9.13271 24.4444 14.4751 26.0421 8.18538 46.692 -8056 4 9.10912 24.9781 13.7161 -5.31341 21.9098 -32.4591 -8057 4 8.68548 23.6494 14.2981 -19.3974 -37.2941 -14.6224 -8058 6 52.771 31.4727 7.38558 20.6973 -2.13415 1.08713 -8059 4 52.3061 32.183 6.93204 -2.34942 2.78723 -4.55897 -8060 4 52.1263 30.9997 7.89938 -16.8139 -9.70652 3.3966 -8061 6 21.3286 5.45224 36.4983 22.333 -40.4406 3.83692 -8062 4 20.7026 5.40277 37.2139 -7.55906 11.9598 8.05023 -8063 4 21.8475 4.61683 36.6516 -9.65069 29.8227 -15.0031 -8064 6 25.1743 37.2092 4.31919 7.23092 6.80805 -6.24923 -8065 4 25.4754 36.7175 3.5165 -8.68629 0.834167 19.7743 -8066 4 24.8491 36.6197 5.01948 2.53349 -5.19005 -7.77823 -8067 6 34.0165 17.4759 18.2358 -58.4306 -31.0723 45.6386 -8068 4 34.1944 16.9598 19.0779 8.50138 15.1756 -22.5601 -8069 4 33.0528 17.7413 18.4058 39.5305 3.9888 -12.396 -8070 6 37.9578 37.5059 25.2944 -35.6234 -15.4362 -10.7836 -8071 4 36.9622 37.6721 25.197 38.0574 -5.35834 -1.14338 -8072 4 38.1643 36.7565 24.689 -7.79603 13.8086 8.25116 -8073 6 5.07735 4.86484 15.8417 42.9381 3.72816 7.10952 -8074 4 5.88838 4.293 15.9163 -33.8081 0.492332 -6.16483 -8075 4 5.50277 5.71956 15.9997 -16.006 -0.473971 1.61617 -8076 6 14.1507 7.19336 7.76886 38.052 -10.4208 -22.4486 -8077 4 13.5129 7.55624 8.34295 -29.9694 15.266 25.1048 -8078 4 13.7195 6.96448 6.9333 -0.98027 3.69224 9.82406 -8079 6 24.98 10.8641 38.0829 22.9212 14.7137 56.6455 -8080 4 25.3157 11.7906 38.09 -5.76353 -21.6486 -14.5596 -8081 4 24.5861 10.6473 37.2742 -21.4949 -6.61803 -48.2716 -8082 6 35.683 7.97762 22.8121 -8.7657 -2.24292 -6.28447 -8083 4 36.2591 8.71308 23.0369 7.49089 3.45465 4.10549 -8084 4 35.4159 8.13228 21.894 -1.16553 2.61323 2.89561 -8085 6 24.8067 29.1485 22.4175 -2.13284 -11.1741 5.39142 -8086 4 24.8847 28.3567 22.9764 5.78872 7.02228 0.265808 -8087 4 23.868 29.1687 22.2304 -8.38579 3.51829 -7.32943 -8088 6 38.496 31.6463 38.4547 5.18571 -7.52333 -11.192 -8089 4 38.5561 32.3892 37.8222 0.442926 -5.96945 11.3455 -8090 4 38.4779 31.9675 39.3579 -6.04594 15.0172 8.52038 -8091 6 7.23911 33.2316 15.4021 21.919 9.41665 12.382 -8092 4 8.12833 33.2899 15.8377 -30.0201 5.59214 -9.80336 -8093 4 7.41373 32.5516 14.7298 -12.8129 5.82399 11.4308 -8094 6 43.353 23.6104 1.44592 7.44142 11.305 12.851 -8095 4 43.1845 24.4377 0.974361 -3.6145 -11.1369 -5.61195 -8096 4 44.1543 23.8467 1.95013 -11.1925 -12.9992 -13.6036 -8097 6 3.53991 32.9016 14.8697 -2.39625 2.76445 6.29056 -8098 4 3.69073 33.2429 13.9877 -3.53656 0.018747 -12.9915 -8099 4 3.78624 33.6349 15.4383 2.83762 5.11564 5.16825 -8100 6 25.3096 21.77 8.26163 -6.66296 0.990367 -4.9072 -8101 4 26.025 21.1206 8.24337 -4.14835 5.1806 10.2199 -8102 4 24.7855 21.68 9.08833 13.2195 -2.77387 -11.0894 -8103 6 43.8224 15.3683 17.7688 -17.5044 -13.9077 -11.4765 -8104 4 43.5422 15.0425 16.8907 -4.65964 7.2866 4.53357 -8105 4 44.7684 15.2434 17.7192 12.2011 1.97977 1.51727 -8106 6 15.7838 16.2525 16.6573 54.0838 12.7989 52.3812 -8107 4 16.4697 16.8261 16.2793 -6.54184 -0.771336 -3.5329 -8108 4 15.1467 16.1661 16.0105 -48.6612 -2.23154 -48.9531 -8109 6 31.9022 12.8519 11.5241 2.75902 49.2592 5.12049 -8110 4 32.4395 13.2725 12.2474 -7.6131 -20.2803 -12.0836 -8111 4 31.5562 13.6461 11.0457 0.0384164 -26.7823 6.27126 -8112 6 18.2248 5.33623 10.1812 -15.488 18.8418 -23.6702 -8113 4 17.7687 5.75894 9.42369 15.7694 -11.8332 4.62439 -8114 4 17.5271 5.29555 10.8288 -1.36455 -9.23689 12.3446 -8115 6 23.0917 39.0779 10.9282 -11.4905 7.21092 -0.352408 -8116 4 23.963 38.6888 10.8472 1.7552 7.95734 1.65941 -8117 4 23.1114 39.9529 10.5005 0.666922 -10.0515 1.633 -8118 6 46.8677 33.7562 8.76248 1.03354 -2.05441 8.38343 -8119 4 46.5037 34.5328 8.27588 2.5022 -8.853 20.9954 -8120 4 47.1475 33.9422 9.6931 -6.44786 13.1686 -22.3696 -8121 6 31.243 39.9317 20.2224 2.33635 -7.70313 -8.05101 -8122 4 30.8704 39.2996 19.5871 0.699046 7.37293 6.91414 -8123 4 32.2017 39.8574 20.0757 -3.27099 6.09826 0.0696837 -8124 6 15.889 33.0919 19.7864 33.8788 -7.40125 -13.3883 -8125 4 16.1628 33.8221 19.1895 -10.4151 -15.5823 0.760964 -8126 4 16.5176 32.3427 19.5839 -16.9866 18.4919 10.6578 -8127 6 32.5555 39.9164 2.66523 30.0039 -10.6491 -2.95451 -8128 4 33.3508 39.5896 3.12591 -10.8726 3.49711 -8.16538 -8129 4 32.1027 40.3655 3.36837 -16.5932 8.39248 6.84073 -8130 6 50.6959 12.1983 3.90519 17.0412 -18.9771 -24.2847 -8131 4 51.4658 12.4814 3.40053 -2.43524 -2.94964 -4.56419 -8132 4 50.632 12.8314 4.58319 -9.04718 30.5099 32.8795 -8133 6 44.7022 2.76366 12.1205 -8.84849 12.6495 8.41904 -8134 4 44.8494 1.8734 11.8267 15.0216 -15.1797 -4.64519 -8135 4 44.7278 2.73137 13.1008 3.87902 2.35132 -20.2006 -8136 6 11.5141 11.9335 31.6448 -3.41939 3.48047 19.9552 -8137 4 11.2577 12.7405 32.1375 2.53248 -5.05318 0.0588515 -8138 4 11.4496 11.2091 32.2982 6.40928 8.91696 -7.15415 -8139 6 4.75269 10.0418 10.4949 -1.19321 15.9867 3.21309 -8140 4 5.0001 10.2283 11.4058 3.15466 -0.54389 -0.234941 -8141 4 4.46559 10.9018 10.1184 3.18705 -14.0527 1.96128 -8142 6 17.0994 25.0099 20.58 37.5195 36.994 -31.4742 -8143 4 16.2483 24.8536 20.9144 -42.3557 -15.7488 8.6923 -8144 4 16.9647 25.6792 19.8535 4.26961 -24.361 15.5384 -8145 6 48.1092 4.75471 14.8037 19.9531 12.9172 -19.4869 -8146 4 47.21 5.0173 14.8371 -33.3483 -4.43172 15.4156 -8147 4 48.388 5.38041 14.11 12.4129 -13.382 8.75366 -8148 6 18.8523 3.11742 3.41631 -21.2483 -3.07087 -4.7476 -8149 4 18.4665 2.24821 3.59937 1.50537 0.955968 2.27262 -8150 4 19.7704 2.98892 3.60058 26.8928 -3.50499 2.30699 -8151 6 35.4247 26.4577 29.0527 -22.8013 -8.66021 5.68805 -8152 4 35.5248 27.2067 28.475 -2.85698 13.778 -9.76065 -8153 4 36.2768 26.0489 29.0602 21.3259 -10.4415 3.203 -8154 6 32.3896 31.2185 12.8503 57.1958 12.7231 -6.23232 -8155 4 31.5925 31.2509 13.3022 -48.7441 2.01486 27.8379 -8156 4 32.2029 30.8426 12.0127 -5.8383 -14.614 -31.3947 -8157 6 33.0076 28.3366 37.5983 -27.3824 -5.67666 30.0102 -8158 4 32.1052 27.9852 37.8568 28.4022 2.55731 -9.07316 -8159 4 33.3988 28.5694 38.4733 -3.969 -4.9759 -22.0899 -8160 6 45.5072 24.7908 10.3169 -45.8214 60.3209 -7.47747 -8161 4 44.9002 25.317 9.70444 28.5781 -13.9385 29.3176 -8162 4 45.5876 23.9971 9.85482 14.9117 -49.3191 -19.3714 -8163 6 14.779 31.7044 3.16918 -45.5594 -6.97168 29.5477 -8164 4 14.0337 32.2859 2.90387 21.9125 -3.3602 -3.07131 -8165 4 14.4311 31.26 3.996 20.2164 14.1486 -26.6391 -8166 6 31.9242 7.68885 4.30286 23.54 -20.9123 31.4536 -8167 4 31.4705 6.84633 4.17995 2.0164 -2.82895 4.59018 -8168 4 31.5931 8.24323 3.64247 -18.259 33.7262 -37.7068 -8169 6 42.5699 17.3136 32.1968 24.1944 7.3606 3.32713 -8170 4 41.6254 17.2329 32.2603 -19.9776 4.79877 -7.53323 -8171 4 42.7917 18.2007 31.8224 -10.4585 -19.5065 0.0265862 -8172 6 13.8071 23.1746 23.5515 16.4347 -15.6283 -2.15259 -8173 4 13.5183 23.7639 24.245 0.233797 9.11225 10.6616 -8174 4 14.6093 22.7029 23.9066 -20.7684 16.5326 -5.05411 -8175 6 10.7126 7.09833 3.97095 14.1471 -33.6721 -68.9477 -8176 4 10.4245 6.93934 4.82914 -14.4566 -0.97954 55.1879 -8177 4 10.4869 6.2311 3.50145 10.3151 35.4271 10.8748 -8178 6 28.7967 8.6797 17.9015 -30.1103 -2.72244 -33.0478 -8179 4 29.5795 8.35746 17.4579 9.90558 -6.78874 -8.85398 -8180 4 28.1705 8.90161 17.1378 19.1156 -3.64084 26.8114 -8181 6 19.4515 29.3423 26.6295 -39.4767 12.5835 42.7579 -8182 4 19.0038 29.6555 27.482 17.5864 -10.0531 -35.2193 -8183 4 20.2946 29.7741 26.6551 17.8114 4.03003 1.9258 -8184 6 40.6571 40.9865 14.5722 30.7749 0.116883 17.4953 -8185 4 40.9453 41.7159 14.038 -4.90719 13.3855 -18.4876 -8186 4 41.4974 40.7167 14.9881 -11.2006 -4.47055 2.16552 -8187 6 46.2595 14.0857 31.7293 11.6035 -9.35965 4.24636 -8188 4 46.4659 13.1386 31.6985 -1.25294 5.8657 1.71226 -8189 4 45.5092 14.1916 31.1613 -13.5258 4.10617 -10.238 -8190 6 36.7111 36.3198 8.38634 20.5175 24.5507 44.7988 -8191 4 36.5848 37.248 8.66174 -25.6048 -20.3538 -28.8485 -8192 4 37.4262 36.1922 9.03978 -4.76011 -28.7723 -18.9481 -8193 6 30.7791 32.4382 38.0814 8.60258 1.74334 21.9396 -8194 4 31.3949 31.9394 37.5795 9.21482 -20.9838 -26.5205 -8195 4 31.4122 32.9586 38.5821 -11.3785 16.1645 3.6603 -8196 6 47.8794 8.8384 10.1746 26.299 41.1069 27.7005 -8197 4 47.2075 9.11907 9.56312 -13.0744 -2.84885 -16.672 -8198 4 48.1152 7.93695 10.1106 -1.40956 -33.8723 -12.987 -8199 6 24.4191 17.0005 30.9872 -11.3759 2.04439 -13.9008 -8200 4 23.6647 16.9339 30.3566 16.9629 0.0568796 9.7226 -8201 4 24.0218 17.1528 31.8579 2.94571 -1.21426 -7.57694 -8202 6 40.5018 5.09847 4.47991 -26.6992 -20.3188 -5.14046 -8203 4 41.28 5.65048 4.47318 14.3705 11.228 -11.5737 -8204 4 40.0798 5.05838 3.58104 19.0568 4.03597 15.916 -8205 6 52.5742 28.0973 6.9077 -25.4379 -29.0344 16.6943 -8206 4 52.3933 28.6001 6.11132 1.2128 1.19853 -1.81518 -8207 4 51.7383 27.5823 7.10916 28.4347 22.908 -9.38917 -8208 6 36.064 32.3866 23.6124 7.53581 -25.1682 -6.10704 -8209 4 36.4508 32.2046 22.7426 1.48893 5.77393 9.47334 -8210 4 35.7934 33.2936 23.5958 -9.41601 17.7382 0.925908 -8211 6 23.6488 31.8764 22.7665 2.85736 4.06253 -9.33391 -8212 4 23.7634 32.5358 22.0878 -9.04528 15.3932 -0.43099 -8213 4 24.3599 31.3007 22.5126 8.23075 -21.5035 13.0322 -8214 6 0.735457 24.4657 41.7131 -9.37188 -1.3071 -20.2528 -8215 4 1.20497 24.8068 40.9273 -3.735 -3.01915 11.177 -8216 4 54.8235 24.2347 41.4089 15.688 5.53844 3.35783 -8217 6 15.9771 8.98022 19.8191 22.6241 -28.8974 20.594 -8218 4 15.5109 8.26292 19.4118 -7.13343 -10.7615 -13.7959 -8219 4 15.6388 9.77471 19.4696 -19.2292 39.8019 -15.8774 -8220 6 33.1716 12.5629 20.0326 13.9441 -12.6476 -4.49459 -8221 4 32.9044 11.6183 19.8429 16.5289 30.3248 6.35834 -8222 4 34.162 12.7185 19.975 -34.5589 -12.2038 -12.3621 -8223 6 7.03971 24.945 26.3683 -0.33354 -9.69316 23.9049 -8224 4 6.80945 24.3756 27.1101 -9.22275 -9.46444 -2.85995 -8225 4 7.84656 25.3251 26.6963 17.391 9.90995 -3.06061 -8226 6 44.4739 22.5508 36.9255 -16.7075 -6.88118 10.4755 -8227 4 43.5027 22.4108 36.9334 15.1456 1.07948 9.67769 -8228 4 44.6732 22.7799 36.0336 3.04889 5.98288 -21.3947 -8229 6 39.2775 23.7142 25.1185 -44.4168 -97.0378 5.9092 -8230 4 39.6033 24.5307 24.937 33.9242 88.3913 -14.6991 -8231 4 38.7559 23.4597 24.3323 8.03463 3.9453 13.1815 -8232 6 20.3756 2.20712 36.9897 -7.56257 -5.27652 1.95266 -8233 4 20.2168 1.45659 37.5665 4.06747 -3.41627 8.94019 -8234 4 20.2802 1.85339 36.1124 5.28277 1.38 -10.8685 -8235 6 22.8571 19.5527 3.6659 6.2145 7.79245 45.4341 -8236 4 22.8782 19.7834 4.64919 -10.5004 -5.13291 -37.3231 -8237 4 23.7426 19.8021 3.38476 9.02488 -3.84737 -6.15569 -8238 6 31.6989 12.5719 34.5929 20.3571 12.3337 69.8717 -8239 4 31.0774 13.2339 35.0297 17.9304 -15.3013 -22.977 -8240 4 32.3378 12.3324 35.3667 -30.4994 7.85147 -45.3393 -8241 6 12.9846 10.2214 25.1019 -30.6317 10.0697 -32.3453 -8242 4 13.6677 9.95937 25.6652 38.8731 -4.05338 37.0168 -8243 4 12.5116 9.4018 25.0264 -11.673 -9.01961 -8.06086 -8244 6 27.2702 0.587979 13.2088 -29.2359 -8.68669 8.17042 -8245 4 27.7024 41.6312 13.2942 -2.56798 3.03598 -7.56301 -8246 4 26.2795 0.464606 13.259 26.6373 -0.778522 -5.81594 -8247 6 5.6575 24.9337 13.9905 13.1991 2.90197 -9.87868 -8248 4 4.70598 24.9553 13.883 -5.9976 0.782062 8.57209 -8249 4 5.90972 25.4072 14.7914 -9.20077 -1.59682 1.38283 -8250 6 22.9799 17.9518 0.527007 -12.0607 -30.0717 13.8125 -8251 4 22.428 18.6392 0.176667 -3.67819 14.6501 -9.17369 -8252 4 22.2816 17.3415 0.914453 31.709 16.1034 -10.9012 -8253 6 33.0985 25.4181 5.46205 -15.7978 -31.0624 1.20161 -8254 4 33.3789 26.3039 5.55078 15.9502 30.9866 -6.27287 -8255 4 32.9645 25.2082 4.52957 3.04969 3.7853 3.27689 -8256 6 8.52872 7.94688 17.4833 18.4257 15.9711 -24.7978 -8257 4 9.39098 8.3855 17.3119 -11.8135 -8.35054 -2.98105 -8258 4 8.4858 7.94817 18.4262 -6.55829 -2.0729 23.5191 -8259 6 26.8237 0.686378 2.88748 4.07 30.2002 2.01549 -8260 4 26.8412 0.391628 3.80568 -3.86709 0.733005 8.35451 -8261 4 26.5975 1.66265 2.91719 8.86873 -29.5911 -1.41132 -8262 6 50.0397 34.7157 15.6267 -11.8175 -1.09292 -1.87233 -8263 4 50.6372 35.2521 15.0721 -14.1207 -5.91477 -4.02646 -8264 4 49.1323 34.6374 15.219 24.748 6.82197 2.94942 -8265 6 46.275 5.00035 11.1282 9.7079 18.7279 -10.06 -8266 4 45.8191 4.20733 11.3912 -11.1099 -14.8598 8.88229 -8267 4 46.9633 4.71614 10.5231 1.70636 -6.51939 -1.67277 -8268 6 33.7833 38.63 35.3851 22.6491 -26.5736 53.3982 -8269 4 34.0604 38.9625 36.3013 -14.2885 -2.00103 -44.5517 -8270 4 33.6201 39.3455 34.786 -2.63152 22.0909 -4.2817 -8271 6 30.8201 25.8435 41.2101 0.522631 -30.718 -12.9218 -8272 4 31.0968 24.9266 41.4082 -1.05643 6.85883 -6.1679 -8273 4 31.1715 26.3436 0.016995 6.66556 20.3816 22.2796 -8274 6 50.2276 0.978128 24.4598 74.6558 22.0158 36.8282 -8275 4 49.5306 0.534407 24.0585 -38.5843 -30.8873 -31.929 -8276 4 51.1134 0.532188 24.3239 -37.6779 9.32343 -0.630533 -8277 6 31.2996 0.720873 19.0302 14.3507 40.5737 -10.6901 -8278 4 30.4605 0.743437 18.5837 -16.9464 -9.10756 -3.3833 -8279 4 31.3343 41.8987 19.5933 -6.31648 -47.867 22.0648 -8280 6 39.0778 29.5479 19.1423 -24.9794 -6.4558 -1.7207 -8281 4 38.1293 29.5816 19.4551 33.1986 -8.08964 -3.40762 -8282 4 39.446 28.6506 19.2986 -6.02354 14.8003 0.990496 -8283 6 21.659 17.5991 25.8953 -11.5386 33.2832 -7.33353 -8284 4 22.0418 18.5204 25.967 -8.02723 -30.5851 6.12101 -8285 4 20.778 17.7492 25.4824 18.7799 -9.30112 4.66445 -8286 6 35.0777 28.803 27.4254 -1.70316 -21.0069 37.4458 -8287 4 35.3301 29.4791 28.0775 3.3924 -2.39002 -8.5847 -8288 4 35.0935 29.2141 26.5843 6.79083 21.8236 -32.9604 -8289 6 30.7137 25.4449 11.6588 -11.4017 25.922 39.321 -8290 4 30.5753 25.9017 12.5616 8.60864 -26.5127 -36.0552 -8291 4 30.5331 26.1452 11.022 4.69716 -0.666916 0.479504 -8292 6 7.33812 15.1344 12.3538 4.68116 -40.544 31.6975 -8293 4 6.75693 14.3594 12.209 2.06777 16.361 -3.14284 -8294 4 7.31295 15.622 11.5607 -9.0052 27.071 -31.8075 -8295 6 16.8334 26.8188 7.04972 -25.5936 3.66279 -30.8653 -8296 4 17.5758 26.708 7.59816 38.4339 -11.2263 23.8467 -8297 4 17.1819 26.9966 6.1597 -5.58153 -2.73835 6.66814 -8298 6 29.5302 33.0784 31.0001 -37.3865 -15.0005 -19.6245 -8299 4 28.6433 32.7554 30.7459 2.04647 15.9344 -4.27919 -8300 4 29.8764 32.2746 31.3613 18.5632 -10.7791 20.7082 -8301 6 14.1048 2.11879 30.9099 -3.69766 -14.7615 43.6071 -8302 4 14.1458 1.95878 31.9138 -8.46722 9.63961 -39.7078 -8303 4 13.6642 1.31591 30.5661 9.09938 8.95306 -0.112961 -8304 6 15.6571 22.2632 2.89617 -37.5764 43.5932 -9.62192 -8305 4 16.4348 21.7941 3.05118 39.5293 -34.0009 4.7875 -8306 4 15.0286 21.6897 2.4522 -3.10464 -12.538 6.06705 -8307 6 23.7259 29.1153 40.9645 17.3396 38.8389 1.6287 -8308 4 23.2818 30.0193 40.9831 11.4767 -32.1544 -0.906545 -8309 4 24.7087 29.2887 40.9216 -25.4222 -7.32646 2.20707 -8310 6 38.1247 14.1642 13.7107 12.8592 31.0763 6.54808 -8311 4 37.6278 13.3808 13.8383 -17.8092 -31.0521 2.1891 -8312 4 38.9029 13.9224 13.2095 7.41852 -3.42228 -8.90759 -8313 6 35.2503 26.5068 15.521 -3.09354 13.3371 19.8917 -8314 4 34.5349 26.5126 14.8818 -0.932758 -4.81772 -4.34805 -8315 4 34.9075 27.0382 16.2823 10.0491 -13.0104 -19.4153 -8316 6 19.0968 34.7379 16.486 5.71756 23.995 22.7437 -8317 4 19.4075 35.6523 16.3704 4.72819 -11.1284 17.3551 -8318 4 19.0401 34.4508 15.6072 -6.41662 -20.6903 -39.0731 -8319 6 18.1723 29.7514 35.7083 20.6671 12.6318 -10.71 -8320 4 18.3041 30.5743 35.1773 -7.60682 -14.8418 20.474 -8321 4 19.0351 29.5718 36.145 -10.3356 2.9076 -6.19235 -8322 6 54.1213 22.2675 24.9131 12.7342 -33.1199 -26.8219 -8323 4 53.6265 21.7967 24.1967 9.15099 10.4438 12.7736 -8324 4 53.5183 22.8995 25.2476 -23.1208 24.5105 7.38222 -8325 6 30.3446 10.3415 34.0026 7.84994 -0.761596 -9.91104 -8326 4 29.5868 10.4349 34.5739 -14.9697 1.07498 11.7851 -8327 4 30.8511 11.1643 34.0933 -4.52293 -3.62201 3.70872 -8328 6 38.3178 33.8965 18.5989 -35.8058 -11.4104 -3.76591 -8329 4 38.923 33.166 18.7063 19.7544 -4.29321 9.06839 -8330 4 38.8137 34.6503 18.3352 23.7539 21.4454 3.52643 -8331 6 22.4873 14.1653 34.4312 -21.9658 -17.0918 -49.1801 -8332 4 22.5571 13.4626 33.7145 -4.81718 29.7264 22.473 -8333 4 23.0772 13.8965 35.1058 26.7449 -1.29975 22.8703 -8334 6 38.021 0.617904 2.36461 -2.26574 -7.91048 -40.4777 -8335 4 37.6239 1.19646 3.0125 3.99393 1.59858 23.4614 -8336 4 38.7851 0.132723 2.71367 -6.22024 4.30596 13.4956 -8337 6 38.885 41.133 10.292 38.4397 69.693 -20.9517 -8338 4 38.7327 0.223589 10.3334 0.502898 -40.1285 -2.38265 -8339 4 38.1678 40.7662 10.7395 -40.074 -22.1176 34.0334 -8340 6 53.417 21.9266 38.962 18.4876 1.53578 17.2983 -8341 4 52.9974 21.8755 38.1026 3.71535 5.74942 -10.4205 -8342 4 54.37 22.1639 38.7939 -25.8904 -11.793 -3.59034 -8343 6 39.9933 12.7125 36.2959 -18.8272 27.1562 12.2819 -8344 4 39.0734 12.4542 36.2547 -7.90274 -1.75871 9.35878 -8345 4 40.3901 12.0873 35.7283 26.8007 -18.4843 -23.2317 -8346 6 48.44 17.2431 40.5981 -19.9836 6.93831 4.04917 -8347 4 47.6199 17.7956 40.4399 22.5854 -23.5642 7.97707 -8348 4 48.3147 16.8142 41.4747 5.07747 10.2388 -9.33604 -8349 6 32.0284 9.3439 40.0151 10.5149 -12.1651 13.6504 -8350 4 32.8546 9.41316 39.523 -1.99935 -3.17675 -6.39298 -8351 4 31.9706 8.39334 40.2816 -10.0936 21.7982 -4.27543 -8352 6 31.75 22.4929 6.3685 -34.2181 3.54143 23.53 -8353 4 31.3779 21.709 6.82557 12.2201 6.35834 -11.7559 -8354 4 31.3059 23.2194 6.8777 16.0591 -13.7554 -15.3432 -8355 6 51.0144 2.58529 21.579 28.4772 -3.64411 10.4611 -8356 4 51.4343 1.72703 21.8198 -11.0001 9.38403 -4.71992 -8357 4 51.7571 3.20177 21.4507 -11.3685 -6.83795 2.38662 -8358 6 13.6247 22.0465 12.1442 29.0901 0.46256 9.76546 -8359 4 14.4578 22.3795 12.5465 -13.9989 1.27328 -8.95219 -8360 4 12.915 22.6494 12.3833 -3.04453 8.5056 -1.94564 -8361 6 23.6209 24.0381 14.6453 -17.5202 11.834 -36.5316 -8362 4 24.2009 24.4886 15.2598 9.8869 4.60732 -3.70937 -8363 4 23.5497 24.6116 13.8304 3.00595 -20.2815 30.972 -8364 6 9.32136 4.85156 31.2387 8.97842 0.466865 -3.67014 -8365 4 8.41764 4.8259 30.9291 -8.7496 -0.132795 -7.84821 -8366 4 9.23666 5.38964 32.029 2.44443 -3.9247 9.21777 -8367 6 16.6769 26.3146 18.0426 -28.7898 -24.0576 -1.25383 -8368 4 15.7763 26.5978 17.7405 22.2361 3.17889 2.46191 -8369 4 17.2688 27.0532 17.9767 7.52301 23.5471 -7.71583 -8370 6 5.12002 13.5179 11.5454 -28.2867 15.553 -42.5279 -8371 4 4.34318 13.4159 12.0982 -3.89331 -5.54815 13.62 -8372 4 4.69334 13.8537 10.6805 23.3071 -7.58808 40.5266 -8373 6 29.613 23.6535 8.07622 4.06305 -5.39054 -18.0309 -8374 4 29.2087 23.3655 8.89798 -2.48969 6.78204 1.65997 -8375 4 29.356 24.5861 7.97247 8.33853 -10.6544 5.22118 -8376 6 0.809058 7.56442 27.8431 6.90575 4.16885 -14.0934 -8377 4 0.916059 7.33161 28.7668 -1.2645 -7.40385 9.39857 -8378 4 1.47033 8.27499 27.7095 -9.19662 -21.8408 -1.77541 -8379 6 15.4183 9.78145 0.490529 10.0725 -7.13925 0.979932 -8380 4 16.087 9.43012 41.8027 -0.259761 -4.12548 -6.98761 -8381 4 15.4693 9.20893 1.26423 -1.27146 5.63374 6.96511 -8382 6 18.8191 0.059487 34.1187 -25.6574 -0.396319 -31.4644 -8383 4 18.4098 41.5755 33.3103 16.2128 4.97009 18.3796 -8384 4 18.5054 0.975155 34.0945 0.533414 5.37151 1.64989 -8385 6 18.7349 30.7803 29.1665 47.4813 -67.7405 25.7886 -8386 4 19.5534 30.6866 29.7899 -42.3671 12.2249 -32.0712 -8387 4 18.5184 31.6699 29.0545 -8.91834 48.7901 3.3651 -8388 6 48.4474 16.4903 36.136 -4.39653 9.55775 -4.4164 -8389 4 47.5651 16.9082 36.2181 15.0357 -0.381514 0.207393 -8390 4 48.471 16.1274 35.2331 3.08724 1.10756 7.15907 -8391 6 43.7979 0.472205 29.2706 42.555 -4.96452 -15.1149 -8392 4 42.8863 0.267919 29.38 -32.9664 -6.64218 10.9475 -8393 4 44.2792 41.5357 29.3524 -8.26894 11.2804 8.78801 -8394 6 16.7205 13.887 21.3769 2.19577 2.66609 -2.49996 -8395 4 16.2052 14.7022 21.5336 6.85381 -11.1318 0.719729 -8396 4 16.6911 13.4037 22.2072 -6.06459 1.50462 5.19021 -8397 6 17.3883 13.4356 26.2524 27.4966 3.2637 -26.6685 -8398 4 18.1303 13.5822 25.5825 -26.8694 -2.13737 32.6247 -8399 4 17.6394 12.6216 26.7148 -3.51452 -0.718268 0.201186 -8400 6 48.1557 10.2329 23.6958 7.66187 -11.6345 21.9365 -8401 4 48.0869 10.5828 24.5972 -4.20109 -8.3855 -4.21906 -8402 4 47.9242 10.9774 23.1563 3.12678 5.33996 -12.4543 -8403 6 28.2651 17.9126 17.8865 15.704 23.8601 -19.8805 -8404 4 29.0328 18.4581 17.6288 -8.16305 -6.08358 1.86534 -8405 4 28.6272 17.0995 18.2183 0.672722 -20.799 10.0784 -8406 6 54.0866 38.1772 23.6885 15.2416 -7.03948 -9.32302 -8407 4 0.015845 37.9236 23.4759 -13.1891 10.5947 7.1207 -8408 4 53.5403 37.6177 23.1226 -4.14834 -2.69562 5.50015 -8409 6 8.47885 18.3973 11.4073 -18.4373 -13.8141 42.9629 -8410 4 7.63335 18.6519 11.0416 -6.40415 6.02722 -6.48684 -8411 4 9.12927 18.583 10.7796 32.3175 8.52747 -41.6205 -8412 6 45.9451 12.8796 11.0371 -17.0736 -2.86831 -37.3051 -8413 4 46.6905 12.613 10.4807 4.61659 2.073 6.35499 -8414 4 45.2044 12.775 10.3831 8.06265 2.44535 24.075 -8415 6 16.2127 8.79404 14.0297 41.7324 -66.6139 22.361 -8416 4 15.4739 9.28873 13.8367 -45.7772 50.9633 -18.0772 -8417 4 17.0286 9.27652 14.012 9.93977 26.888 -8.08533 -8418 6 42.7214 13.3612 21.3881 16.6788 44.7105 -2.77317 -8419 4 41.8036 13.1589 21.3301 -20.1042 -28.5105 -1.62877 -8420 4 42.6833 14.2978 21.1276 5.52546 -8.26362 1.62797 -8421 6 21.0018 40.4256 16.4674 21.2457 -19.0828 1.73859 -8422 4 20.7372 40.049 17.3276 2.67731 3.65462 -7.46566 -8423 4 21.8606 39.9985 16.1939 -29.0987 10.293 9.55187 -8424 6 45.6337 11.4313 32.9356 51.1157 -40.0447 2.01383 -8425 4 46.3303 10.7696 33.2563 -29.172 28.0234 -20.2541 -8426 4 45.1866 11.676 33.7277 -20.3741 9.53259 21.5498 -8427 6 26.9484 8.87146 24.2965 48.4346 1.85391 18.4292 -8428 4 27.5311 9.68141 24.3337 -29.9021 -15.2605 -8.39328 -8429 4 27.4823 8.26118 24.8676 -16.4416 6.67878 -12.0087 -8430 6 18.977 2.43413 29.3663 0.758316 16.52 -7.40381 -8431 4 18.1944 2.4248 29.9271 -0.767207 -2.12047 7.99903 -8432 4 19.1173 3.36872 29.101 -3.03797 -9.07666 7.57415 -8433 6 8.2454 29.1679 19.723 -8.63488 -12.9151 21.1286 -8434 4 8.14448 28.8871 20.6627 3.14293 7.67545 -21.2948 -8435 4 7.83715 28.464 19.1969 -1.03495 3.62674 2.54809 -8436 6 9.03976 34.3129 18.6533 -7.54593 -6.72093 -3.09965 -8437 4 8.77081 34.2931 19.577 -0.177883 2.97642 -7.59668 -8438 4 9.06659 35.2455 18.4187 6.50563 1.62734 -4.46359 -8439 6 10.1892 11.9266 11.2355 -21.5107 11.0325 -1.739 -8440 4 10.2333 12.874 11.065 17.4692 -2.43612 -1.88546 -8441 4 9.23632 11.7983 11.121 5.09535 -6.80078 4.24402 -8442 6 35.7546 21.6858 36.1669 -23.2352 21.9394 0.834429 -8443 4 35.0265 22.3595 36.1433 18.2091 -18.4066 2.26802 -8444 4 36.3924 22.0173 36.8321 -9.99636 -6.87572 -9.75527 -8445 6 17.0812 12.5048 36.3903 -12.1142 25.6516 12.5185 -8446 4 17.3175 12.8308 37.2812 -0.49448 -9.18651 -10.1264 -8447 4 17.5662 11.7075 36.2155 7.76979 -20.5663 -1.07791 -8448 6 37.1566 13.0227 34.2843 -17.9764 -6.1284 -55.2853 -8449 4 36.5549 12.2662 34.3472 4.68366 1.60167 -17.3784 -8450 4 37.3932 13.1268 35.1567 14.9075 13.7384 64.605 -8451 6 38.9862 29.5501 13.2301 -1.89389 21.6683 -7.70005 -8452 4 38.7944 28.7085 12.8419 -2.19861 -17.9948 -10.7911 -8453 4 38.6501 29.4932 14.1174 1.27468 3.77518 16.782 -8454 6 0.176516 29.3495 29.4845 -12.5141 10.2637 -5.31555 -8455 4 0.737394 28.6151 29.2028 3.82179 3.49987 -8.15609 -8456 4 54.9814 29.9211 28.6995 5.57042 -17.7863 13.6106 -8457 6 15.9458 0.256833 12.7596 -44.0073 4.56069 2.48191 -8458 4 15.316 0.578271 12.0799 19.6091 -0.692249 -3.06606 -8459 4 15.3039 41.7798 13.3939 19.5978 -0.7471 3.56907 -8460 6 3.99127 11.9482 8.78851 -15.4327 -39.7622 32.4444 -8461 4 4.35413 11.6179 7.97869 6.27746 3.41828 -23.4587 -8462 4 3.98972 12.8788 8.75552 1.02746 43.1268 -6.73396 -8463 6 24.041 23.6822 19.9783 33.1595 11.366 0.122861 -8464 4 23.6132 22.8866 19.7159 -20.0299 -17.1205 -2.84168 -8465 4 23.4218 24.2757 20.3917 -9.46777 4.2557 4.80954 -8466 6 4.48057 2.29323 23.9805 -22.9759 10.1361 69.4322 -8467 4 4.73792 2.40802 23.1034 3.49419 10.2026 -52.1527 -8468 4 3.69711 2.85929 24.1902 11.7092 -10.5693 -13.4065 -8469 6 33.0966 27.663 33.8386 -28.073 -12.9468 -7.71443 -8470 4 33.3687 28.5694 33.7309 6.85765 13.8135 -2.76136 -8471 4 33.7449 27.1385 34.2981 13.436 1.78162 12.2729 -8472 6 11.3912 21.7129 6.08719 -17.5666 -2.19741 -2.39462 -8473 4 12.3323 21.6847 6.05692 28.5529 -3.65784 2.285 -8474 4 11.1694 22.1681 5.26899 -4.22105 -2.6604 -2.39966 -8475 6 37.2225 13.5364 23.6261 -18.6729 23.2035 4.88571 -8476 4 37.3138 14.0862 24.4412 -7.0733 -14.7121 -13.3014 -8477 4 37.9734 12.9786 23.5155 30.7338 -8.31921 -1.90296 -8478 6 5.00503 21.0366 33.3647 1.8453 38.5327 -33.3657 -8479 4 4.21257 21.4237 32.9267 15.1329 -13.9269 -2.57683 -8480 4 4.69097 20.5075 34.0602 -12.1996 -25.3348 31.8286 -8481 6 18.1998 37.5792 26.9379 10.6598 2.97497 -14.5277 -8482 4 17.7896 38.4267 27.1371 3.99806 -1.69574 -0.528064 -8483 4 18.8493 37.7746 26.2284 -6.0853 -8.42077 12.5802 -8484 6 19.7447 16.1537 4.6847 3.25094 -1.99961 -5.02271 -8485 4 18.927 15.8729 5.11398 3.02189 5.09699 3.93014 -8486 4 20.4865 15.8366 5.22215 -5.31395 3.35724 3.77112 -8487 6 54.074 32.5125 15.5854 10.3761 -37.3618 -30.9158 -8488 4 54.8842 32.2065 16.0104 -1.29748 4.29224 -6.87141 -8489 4 53.7047 33.0976 16.2003 -18.9781 34.1452 25.1436 -8490 6 31.1314 3.81684 36.7321 -0.834289 -2.49025 -7.10722 -8491 4 31.1103 4.02948 37.6722 -6.54843 -2.60835 4.18586 -8492 4 30.7135 2.95482 36.5673 3.74099 5.55874 7.56308 -8493 6 11.8386 14.3591 5.9475 31.6488 6.08621 47.6135 -8494 4 11.9235 13.4381 5.72501 -3.84758 -8.60837 -9.73648 -8495 4 12.4264 14.4198 6.78937 -30.0453 0.761866 -39.8937 -8496 6 30.4739 33.6971 6.46755 -23.3776 20.1936 16.0158 -8497 4 30.0841 33.0849 7.09297 -6.22519 -2.1618 10.9649 -8498 4 31.0937 33.1726 6.0102 25.8315 -23.5027 -25.5745 -8499 6 12.7945 0.536645 21.6661 -31.9857 18.4102 -14.2222 -8500 4 12.046 0.975194 21.1709 21.6431 -18.6961 6.09473 -8501 4 12.7507 0.998686 22.5059 13.427 -0.157027 11.5383 -8502 6 52.7685 7.22113 26.1957 6.97037 27.5507 21.845 -8503 4 53.4259 7.92282 26.4698 -21.5773 -21.2317 -16.9414 -8504 4 53.0823 6.78628 25.4103 4.46247 -3.68205 -10.7225 -8505 6 39.7279 40.8849 3.7445 22.9677 17.8938 -40.8272 -8506 4 39.3244 40.0392 3.76563 -12.6427 -25.5287 10.0743 -8507 4 39.6614 41.3038 4.58361 -3.65945 6.85452 27.763 -8508 6 20.1085 31.9188 21.9984 -7.05206 -5.67602 7.13377 -8509 4 19.4287 32.0842 22.6964 14.9272 -8.91322 -13.6161 -8510 4 20.3617 32.7769 21.6609 2.64243 15.0084 0.0829653 -8511 6 12.8674 35.0052 4.44359 43.5281 -46.0898 9.1613 -8512 4 12.2643 35.7062 4.40975 -34.4326 42.8527 -2.74399 -8513 4 13.784 35.3443 4.35073 -14.7319 6.47242 -4.65586 -8514 6 24.0589 33.6612 24.8588 9.55704 11.7193 -6.52578 -8515 4 23.7303 32.9012 24.3903 -5.13736 -12.3884 -10.0474 -8516 4 24.8786 33.8838 24.3903 -2.58553 -1.28908 -1.69824 -8517 6 40.1426 40.9082 22.7393 38.5538 -20.8809 37.5387 -8518 4 39.5402 41.0833 22.0513 -32.6743 7.60774 -19.3027 -8519 4 39.6696 40.5795 23.5226 -1.01773 2.4492 -9.99125 -8520 6 15.5532 2.81426 38.4448 -20.0738 34.0709 23.3703 -8521 4 14.8967 3.48174 38.7749 9.17215 -23.4566 -12.8824 -8522 4 16.1607 3.33672 37.9186 19.8661 -0.634992 -1.43825 -8523 6 41.016 9.18565 16.9561 17.4117 -10.7022 -18.9926 -8524 4 41.8597 8.69641 16.8054 -9.41989 12.8418 6.23764 -8525 4 40.6131 8.73354 17.6887 -9.17188 -2.41438 15.2761 -8526 6 43.1923 41.3931 9.58697 -22.3356 -19.1489 -3.62619 -8527 4 42.3612 40.9845 9.24256 14.3618 0.824315 8.65898 -8528 4 43.3433 0.185675 8.9708 1.58778 19.1204 -6.9238 -8529 6 24.903 37.9158 30.7914 -43.8554 -5.41491 21.3724 -8530 4 23.952 37.804 31.173 48.4757 4.96182 -14.1951 -8531 4 24.7905 38.4252 29.9913 -4.69729 3.46822 -12.8277 -8532 6 2.22055 5.32897 16.4318 -0.704957 11.5959 2.51569 -8533 4 1.8086 4.56809 16.8519 3.25773 -6.94195 4.1641 -8534 4 3.17492 5.17974 16.3235 -2.45649 -10.6256 -1.35481 -8535 6 1.39662 14.9371 19.1386 6.71081 10.2639 18.1623 -8536 4 0.558182 14.6006 18.8448 -10.0768 -10.7254 -15.2923 -8537 4 1.25744 14.8844 20.1022 8.06638 5.64899 -3.4629 -8538 6 34.3184 26.5435 23.7018 12.956 38.2174 -10.8067 -8539 4 33.6096 26.6326 23.0506 -6.28704 -5.42218 7.19498 -8540 4 34.253 25.729 24.1673 -8.0715 -30.4977 4.91012 -8541 6 41.932 21.8144 37.5476 -28.1346 24.458 10.6264 -8542 4 41.9653 21.2973 38.3662 8.82952 -0.726087 -9.88338 -8543 4 41.2985 22.5209 37.8344 14.7394 -10.5077 -10.9774 -8544 6 39.4289 37.6722 12.6363 -7.06663 36.6798 -8.56095 -8545 4 38.7214 38.0767 13.1674 9.12422 -13.2372 3.4836 -8546 4 39.8791 38.4903 12.2996 -0.376717 -30.7746 7.3995 -8547 6 30.2308 35.8744 2.88429 56.3256 -5.17531 19.584 -8548 4 29.7395 35.078 2.8871 -14.5394 -27.2578 -4.40621 -8549 4 29.6846 36.541 2.55195 -33.266 39.3858 -14.7027 -8550 6 50.3691 12.2996 11.0379 -10.7742 -32.245 -38.7061 -8551 4 50.5492 13.1381 11.4098 4.20277 26.7051 25.7379 -8552 4 50.0731 11.6929 11.7162 -2.05651 -3.66514 15.0978 -8553 6 38.4203 1.52686 34.6552 6.3891 -23.1477 32.9209 -8554 4 38.2942 1.9363 33.8354 -7.66336 30.6162 -40.7111 -8555 4 38.1079 0.632206 34.5078 -6.35148 -11.0336 -1.97829 -8556 6 23.4679 32.2557 29.2149 -43.4567 -12.6916 53.2324 -8557 4 24.0296 32.8423 28.7424 12.6247 17.2837 -9.6693 -8558 4 23.1232 32.6929 30.0761 24.9901 -11.6617 -44.232 -8559 6 36.561 38.8488 8.89417 42.7368 2.70764 46.8348 -8560 4 35.962 39.5202 8.64255 -29.9788 24.4889 -23.0747 -8561 4 36.8832 39.1244 9.78764 -11.193 -6.37855 -17.8717 -8562 6 35.882 15.8491 32.4345 4.38917 24.4094 -11.8898 -8563 4 36.1253 15.4284 33.2547 4.1797 -3.844 11.2859 -8564 4 36.4849 16.63 32.3181 -12.6028 -21.8682 2.29862 -8565 6 22.2747 21.8257 41.5848 1.63659 45.0851 -0.0273952 -8566 4 22.1351 22.8132 41.5538 -4.13496 -33.3395 13.1468 -8567 4 23.0832 21.7834 41.079 15.3069 -18.439 -3.51535 -8568 6 24.3693 38.6933 37.0124 5.99709 22.8296 -9.01594 -8569 4 25.2224 39.1901 37.0147 -13.2325 -18.2305 -0.0611307 -8570 4 24.4452 38.0141 37.6805 1.8393 -10.9749 7.25289 -8571 6 45.85 22.0674 16.0435 -6.35855 -11.009 -33.5755 -8572 4 46.1693 22.2375 15.1223 -5.70657 5.73574 25.2515 -8573 4 45.3177 21.2496 15.9445 13.424 8.98362 5.88408 -8574 6 34.0938 26.1451 39.6028 29.3502 -8.72422 32.5359 -8575 4 33.1775 26.2044 39.4639 -36.6108 3.5864 -15.8394 -8576 4 34.1454 26.1252 40.583 9.60862 3.8872 -14.9166 -8577 6 7.22316 36.161 23.2803 -75.9344 2.48999 -44.2827 -8578 4 7.2061 37.0658 22.9632 2.60813 8.07149 -4.69042 -8579 4 7.98979 36.1134 23.7455 79.8131 -8.28428 52.3852 -8580 6 29.1469 40.7664 9.14908 25.9603 -62.9641 -41.536 -8581 4 29.104 40.2522 8.28913 -11.1672 35.4313 19.904 -8582 4 29.7179 40.1086 9.59652 -3.22944 23.7461 21.8778 -8583 6 29.3725 11.2348 1.3024 -38.7794 14.8627 17.4065 -8584 4 28.4703 11.3821 0.891273 31.6728 -0.63192 16.6295 -8585 4 29.2803 11.4968 2.26097 5.36173 -12.1272 -32.3877 -8586 6 30.9813 3.70043 14.0775 0.393287 -12.1193 -7.6118 -8587 4 31.3533 2.81844 14.3971 -7.37725 32.1126 -17.4345 -8588 4 30.796 3.71521 13.098 8.52465 -17.2224 25.8707 -8589 6 29.7018 15.2871 38.2765 -11.7342 18.5436 -44.4423 -8590 4 30.2882 15.1814 38.9925 24.3773 -7.28175 32.8118 -8591 4 30.1059 15.9805 37.6877 -12.7379 -16.9908 17.8861 -8592 6 36.618 0.316233 29.1564 -1.13478 17.6011 -18.8673 -8593 4 37.4497 0.805382 29.2328 -0.537074 -5.31334 10.7084 -8594 4 36.0611 0.935156 28.6408 3.38103 -20.3125 11.7491 -8595 6 47.6566 0.117823 23.249 5.11875 5.73062 -10.5794 -8596 4 46.969 0.414744 23.8324 -12.4062 9.53281 16.9836 -8597 4 47.4018 41.1354 23.0496 0.315762 -17.3342 0.264415 -8598 6 7.91605 37.1729 29.9478 9.96828 38.7234 29.3851 -8599 4 7.8238 37.3188 30.9485 4.22886 -13.4646 -46.5453 -8600 4 8.48708 37.9472 29.6677 -24.8232 -29.7333 9.09982 -8601 6 38.925 24.2263 12.6374 28.6028 -18.1679 -25.4959 -8602 4 37.978 24.1747 12.7226 -16.6271 -1.4443 2.40459 -8603 4 39.1586 23.5255 11.9538 -9.24307 26.9603 22.464 -8604 6 21.3053 26.2545 36.7859 14.9917 45.9325 1.16 -8605 4 20.8074 25.7232 36.1994 -14.2562 -21.9874 -17.8757 -8606 4 21.6248 25.6951 37.4625 3.91421 -21.0802 23.8691 -8607 6 28.2258 23.3284 24.9888 19.6442 1.87868 9.60148 -8608 4 28.2493 24.0261 25.6588 -3.93467 -3.60043 -2.01642 -8609 4 29.1002 22.8932 25.0573 -18.3502 1.43704 -4.70914 -8610 6 38.4116 39.5691 14.5896 29.669 -4.24194 25.1928 -8611 4 38.4978 38.8692 15.3261 -6.52385 31.9806 -37.1925 -8612 4 39.2924 40.0897 14.6163 -46.5668 -30.9815 -6.21074 -8613 6 26.0432 5.99751 38.1148 44.5658 1.98351 30.7371 -8614 4 26.452 6.86444 38.1066 -12.5768 15.2327 -11.4433 -8615 4 26.7959 5.51316 38.5398 -27.2991 -6.53191 -16.0548 -8616 6 52.1237 17.2497 22.5073 -27.4301 16.765 14.7973 -8617 4 52.9399 17.665 22.2571 16.5652 5.20466 -11.3284 -8618 4 52.1578 16.3131 22.3678 7.8945 -19.2066 -9.92552 -8619 6 39.5302 30.1999 31.4498 -15.3908 2.56685 75.4769 -8620 4 40.0207 30.5437 32.2484 0.473519 -4.28305 -35.1019 -8621 4 38.713 29.8928 31.926 18.6512 10.8404 -28.7426 -8622 6 19.6503 6.93083 12.7623 15.8343 -24.4908 21.6207 -8623 4 19.8732 6.46228 13.5959 -20.1786 11.9342 -5.76682 -8624 4 20.303 6.55009 12.1776 -0.0209149 2.55819 -14.5973 -8625 6 32.4196 37.4972 40.0987 12.4446 10.4582 -32.0511 -8626 4 32.8186 36.647 40.0719 9.51079 -23.9505 -16.9607 -8627 4 32.1638 37.519 40.9804 -20.9873 13.1856 56.2462 -8628 6 39.7646 0.344956 6.09395 -0.813604 -13.3118 11.6504 -8629 4 40.0929 1.25666 6.05063 3.72657 -6.06719 5.14874 -8630 4 40.1279 41.7919 6.88268 -2.2039 13.7644 -10.8213 -8631 6 28.7754 10.1494 29.1547 6.27663 8.45441 -17.0952 -8632 4 27.8341 10.1814 28.9557 -5.13507 -0.906004 3.81537 -8633 4 28.9096 9.91312 30.0774 -3.02611 -6.60467 -0.689697 -8634 6 28.3509 21.0738 10.6423 20.1214 -0.517468 -23.7169 -8635 4 28.7452 21.9678 10.604 -10.1652 -7.70852 11.001 -8636 4 28.9796 20.5469 10.1008 -17.263 7.26144 14.8814 -8637 6 27.0689 28.6853 20.8654 35.4789 -5.63144 4.47554 -8638 4 27.7442 29.2307 21.3162 -7.53329 -4.62114 -3.00727 -8639 4 26.2324 28.9644 21.1916 -29.8949 8.87289 15.491 -8640 6 39.6884 13.9755 33.4499 14.6401 2.99861 16.5486 -8641 4 40.0373 13.7827 34.3426 -3.85296 -1.51256 -14.2832 -8642 4 38.7457 13.8219 33.5285 -9.87208 -9.87778 -3.27097 -8643 6 25.4679 11.6581 34.316 -5.2989 -28.5582 40.5924 -8644 4 24.7613 11.1605 34.7897 20.9725 -0.466275 -6.59756 -8645 4 25.003 12.0579 33.6214 -16.717 25.3404 -32.2266 -8646 6 27.5101 37.647 21.4263 -39.7295 -31.2682 -35.969 -8647 4 28.2375 37.1633 21.0518 17.2189 -6.02702 -9.55939 -8648 4 27.8241 38.1534 22.1272 30.3423 24.6719 41.8853 -8649 6 30.5838 20.0489 28.6446 73.221 13.9737 -1.42059 -8650 4 31.1441 19.3945 29.1273 -28.9524 12.9537 -8.0961 -8651 4 29.6632 19.9528 28.6439 -45.0502 -19.2043 6.90743 -8652 6 42.3833 1.8554 14.9243 13.367 3.08275 38.4467 -8653 4 41.8907 2.29225 15.634 5.99337 6.74303 1.17955 -8654 4 41.7769 1.84183 14.2131 -17.6385 -4.20156 -32.9301 -8655 6 12.1633 12.5377 19.5325 -23.0245 -19.867 -11.1113 -8656 4 12.9521 12.0237 19.3369 9.43068 0.576721 5.46819 -8657 4 11.4219 11.8853 19.4518 12.4737 16.4774 1.27947 -8658 6 19.216 1.20416 16.3541 12.5689 2.54581 22.2585 -8659 4 19.6937 0.628292 16.9879 -4.91383 6.35485 -14.1526 -8660 4 19.7889 1.98236 16.2594 -2.22189 -4.72354 -7.2618 -8661 6 9.47695 16.1439 27.6873 23.0793 15.684 -40.8775 -8662 4 9.87411 15.9669 26.7875 -8.00596 11.4199 30.6292 -8663 4 9.27844 15.2819 28.0019 -12.6146 -24.0632 14.4486 -8664 6 40.4558 26.1873 24.7848 -5.87099 -8.07067 -10.9608 -8665 4 40.3772 26.6753 25.6381 -3.45584 0.121614 -18.2296 -8666 4 40.075 26.6842 24.0102 9.21367 0.234889 33.0434 -8667 6 47.6742 17.6493 18.027 -37.0889 26.6143 -3.73366 -8668 4 48.2089 18.0323 18.7522 -4.76487 -3.2939 -8.20899 -8669 4 46.8388 18.2201 17.9217 41.9344 -19.3622 12.4897 -8670 6 36.6073 25.2802 4.19388 18.2149 -9.73143 -24.5863 -8671 4 36.604 25.3887 5.14943 -0.00537736 13.7381 3.83127 -8672 4 37.3627 25.7621 3.76942 -18.9403 0.329358 18.8416 -8673 6 39.5721 35.375 29.6682 7.39129 29.0443 4.37935 -8674 4 38.9992 34.6325 29.7528 -8.39079 -18.7886 -5.10368 -8675 4 39.3389 35.9401 30.4162 6.41301 -4.37294 -4.4287 -8676 6 0.402862 14.6299 13.3406 12.3375 -5.37043 -32.3015 -8677 4 54.737 15.2477 13.6388 -5.18731 7.44473 4.40324 -8678 4 0.540834 14.0191 14.0401 1.19186 -14.994 25.3978 -8679 6 12.2127 27.3484 8.43247 -29.2387 -0.771708 1.75024 -8680 4 12.965 26.7512 8.46983 14.5311 5.0326 6.8656 -8681 4 12.3156 28.1607 8.97491 11.1816 -11.3427 -11.9337 -8682 6 36.8986 14.8167 21.1188 31.0797 27.7575 -31.2238 -8683 4 37.0397 14.394 21.9547 2.6333 -10.7207 26.6181 -8684 4 37.7308 15.3371 20.9125 -24.2604 -24.0664 4.77074 -8685 6 20.8464 4.94114 21.1044 31.4042 5.97012 13.2179 -8686 4 20.3644 5.60924 21.5958 -5.50293 4.43366 -4.7096 -8687 4 21.773 5.03668 21.4416 -23.5272 -13.3128 -11.683 -8688 6 36.7544 1.79945 7.61694 -30.3574 47.6061 45.3867 -8689 4 36.327 2.6686 7.87118 16.8784 -26.1974 -29.8241 -8690 4 36.8428 1.50799 8.53455 15.1793 -22.3797 -11.8231 -8691 6 12.2439 31.5023 37.4569 -32.4985 -2.96535 6.06153 -8692 4 12.7586 31.1596 36.7365 10.4364 1.05198 -9.11954 -8693 4 11.3919 31.0227 37.3953 11.2973 8.58078 9.3944 -8694 6 38.9908 41.586 16.881 -5.73716 8.1645 -10.5856 -8695 4 39.3046 41.7073 15.9766 4.30886 -9.33368 3.06156 -8696 4 39.3667 0.405687 17.3669 3.77504 10.3777 9.96207 -8697 6 31.8904 27.2678 22.2602 -2.97266 4.85738 -46.2508 -8698 4 31.2122 26.6002 22.3915 1.88455 0.488126 10.0993 -8699 4 31.7489 27.4981 21.2895 3.71213 -3.79941 38.8104 -8700 6 42.7405 9.18554 25.589 -22.1194 -12.6454 -9.25487 -8701 4 42.0872 8.82691 24.9599 0.650449 1.17306 7.26361 -8702 4 43.4011 9.54846 25.0154 21.3216 10.0262 -4.62936 -8703 6 50.9383 28.1736 25.3544 -13.6318 0.0171378 28.1732 -8704 4 50.4953 27.5553 24.7803 -5.9639 1.72187 -15.2616 -8705 4 50.5272 27.9992 26.2251 14.2447 5.57945 -12.3971 -8706 6 43.1888 19.6578 30.9105 -66.6531 23.7889 25.5358 -8707 4 44.0873 19.829 30.8982 70.1332 9.75906 -5.84371 -8708 4 42.7965 20.4661 31.3425 9.97757 -17.7871 -10.1322 -8709 6 30.6644 14.0457 40.7997 -18.1309 16.7334 54.243 -8710 4 30.3214 14.3504 41.7092 15.0959 -2.90855 -40.5845 -8711 4 30.1739 13.231 40.7145 -1.19418 -16.8866 -12.4659 -8712 6 20.9131 15.4897 23.0235 5.61878 12.7036 12.8066 -8713 4 20.368 16.1905 23.4302 1.66694 -9.32372 -6.67403 -8714 4 21.8218 15.751 23.2692 -7.37195 -9.57776 -6.18749 -8715 6 34.2171 0.764056 35.8253 8.40959 -35.3498 44.9304 -8716 4 34.6567 1.46863 36.3417 -5.08936 -9.30099 -7.81199 -8717 4 34.1194 41.866 36.4755 2.29033 39.9746 -37.3302 -8718 6 38.9162 36.9098 35.9203 10.0793 6.80115 3.36275 -8719 4 39.7784 37.1612 36.3284 -16.0364 -11.2649 -5.21842 -8720 4 38.6132 36.0588 36.2696 9.66804 2.35098 0.533126 -8721 6 45.1336 25.2146 22.7744 -28.8992 3.863 21.2581 -8722 4 44.1561 25.0943 22.7165 17.1243 8.87651 18.653 -8723 4 45.3983 24.7563 22.0047 17.0602 -12.3694 -29.5411 -8724 6 40.597 0.8134 35.9421 3.227 69.6319 -3.88491 -8725 4 40.5509 41.8059 36.0096 -6.03355 -53.2669 -4.53187 -8726 4 39.9427 1.13471 35.2813 10.0151 -17.6297 16.5691 -8727 6 11.0455 28.3465 35.0235 9.7668 1.71998 -0.601403 -8728 4 10.9819 27.7367 35.7737 -0.960779 4.073 1.47136 -8729 4 10.3922 29.0422 35.1677 -11.8786 -4.48184 3.12795 -8730 6 20.2051 13.5934 35.8566 39.7213 -43.4527 45.4399 -8731 4 19.4813 14.0017 35.4777 -48.9883 30.031 -35.164 -8732 4 20.9868 14.0394 35.5673 14.4182 15.1 -18.5178 -8733 6 39.6245 5.13776 1.76997 -0.951619 9.89005 21.073 -8734 4 38.8252 4.77089 1.41386 -14.9185 -6.12031 -3.7056 -8735 4 40.3018 4.93211 1.13633 15.4903 5.30459 -14.5773 -8736 6 30.2698 30.8736 32.4375 -6.71798 15.6036 14.0469 -8737 4 29.6901 31.1438 33.1751 5.76607 1.99955 -8.25679 -8738 4 29.7896 30.1731 32.0039 1.14172 -17.9152 -6.50707 -8739 6 14.5598 11.0088 22.8703 10.5759 -0.53797 13.7125 -8740 4 15.2344 11.6195 23.3114 -32.0235 -23.0075 -11.5695 -8741 4 13.848 10.7777 23.5118 19.1574 10.2796 -1.34673 -8742 6 20.7379 13.9443 3.00881 5.16887 -45.0314 -26.4616 -8743 4 19.9261 13.6658 2.50706 22.866 18.233 23.793 -8744 4 20.5244 14.6819 3.55007 -16.1173 25.3417 12.2311 -8745 6 41.3029 4.28468 12.6203 -8.04128 10.917 21.7417 -8746 4 40.6152 3.63858 12.7642 -6.82471 -4.23516 2.09603 -8747 4 41.6484 4.11485 11.7651 11.719 -9.67534 -28.974 -8748 6 10.8581 24.7328 21.7161 -39.3585 -15.8792 -33.4515 -8749 4 10.0068 24.8598 21.1989 28.1112 14.2693 20.1969 -8750 4 11.1639 23.9123 21.3137 10.3572 -6.50453 7.69671 -8751 6 53.5762 20.8825 34.3773 -29.6915 -0.0415475 -3.94304 -8752 4 54.5085 20.795 34.3185 33.8519 4.29786 -2.30511 -8753 4 53.2552 20.0612 34.7861 8.83511 12.9473 -9.59804 -8754 6 14.8838 4.84499 30.449 -1.65326 0.839716 -13.8987 -8755 4 14.8578 5.00753 29.4799 -4.93385 -7.75961 17.951 -8756 4 14.5437 3.94124 30.5804 2.28716 7.27432 -2.63088 -8757 6 48.9137 37.1159 13.1232 -44.1315 32.6594 -31.0851 -8758 4 47.9268 37.1149 13.1949 24.5681 4.85746 10.1076 -8759 4 49.2024 36.4546 13.7037 17.9017 -30.2536 24.0784 -8760 6 26.8017 19.3068 7.5379 -15.1037 -1.6612 14.6377 -8761 4 27.3245 18.5243 7.34583 -2.01051 -6.65035 -9.19035 -8762 4 27.3053 20.0577 7.2492 18.4232 10.5976 -10.0514 -8763 6 17.631 11.9383 39.0904 -43.3265 13.8677 10.122 -8764 4 18.4941 11.6307 38.9203 38.4816 -13.6738 2.54756 -8765 4 17.5009 12.0978 40.0481 6.31677 -1.58465 -10.4285 -8766 6 49.9233 14.5931 8.61354 5.83785 -36.2985 -8.08798 -8767 4 49.214 13.9285 8.60404 6.89175 6.08198 5.75816 -8768 4 49.5175 15.3796 8.93642 -5.42274 33.9852 6.11405 -8769 6 32.3642 34.9667 31.5078 2.95354 23.7899 20.5819 -8770 4 32.072 34.4222 30.8036 -4.84614 -18.7532 -16.6478 -8771 4 32.4643 35.8463 31.1217 -0.970967 -0.757054 5.3462 -8772 6 11.8286 22.2266 21.3061 -17.2258 -15.6378 -41.9552 -8773 4 12.2171 21.6669 20.5638 -11.8041 19.7065 26.8676 -8774 4 12.3859 22.1258 22.0497 29.6948 -3.02551 21.8379 -8775 6 33.8509 9.96106 13.6416 -14.3875 -24.3714 -53.1057 -8776 4 33.0123 9.50508 13.4028 8.15621 17.9807 22.2309 -8777 4 34.3201 9.78154 12.7883 7.50726 12.1846 28.7729 -8778 6 25.5192 36.3946 1.51103 -10.4602 3.19395 -11.4439 -8779 4 26.0842 36.7323 0.810141 8.62195 6.50952 5.56913 -8780 4 24.6933 36.9065 1.40961 6.72848 -10.059 1.65156 -8781 6 26.2721 10.5411 9.76409 -19.2005 -4.19702 2.88354 -8782 4 25.6096 11.193 9.42675 5.9346 -6.99241 18.1855 -8783 4 25.839 9.94226 10.4354 7.43867 25.8511 -14.7334 -8784 6 25.016 0.794303 40.8954 13.3669 6.17095 4.00755 -8785 4 25.3682 0.342397 40.1084 -6.19889 9.04785 1.09472 -8786 4 25.4075 1.69244 40.9338 -2.19893 -14.7289 -5.24662 -8787 6 46.2434 3.93626 24.8203 6.94819 -22.6825 -8.03363 -8788 4 46.3834 4.04208 23.8743 3.61713 6.01616 -2.12387 -8789 4 46.2394 2.96647 24.9181 -8.37252 7.22853 3.62774 -8790 6 21.5889 13.6037 29.2057 4.95103 8.76674 17.4208 -8791 4 21.6019 14.3052 29.8879 -2.51331 -9.966 -5.68557 -8792 4 21.3126 14.082 28.4253 -2.16645 0.501775 -6.52993 -8793 6 36.7737 38.3803 0.360926 -13.0762 -25.442 -6.6792 -8794 4 36.4499 39.0355 0.978203 -4.80976 12.188 0.88021 -8795 4 36.0266 37.7487 0.22189 15.835 12.8395 4.19355 -8796 6 19.3086 17.6338 24.0617 47.0109 35.6134 -17.5995 -8797 4 18.4263 17.3722 24.1632 -50.3154 -15.1751 2.93786 -8798 4 19.3137 18.3511 23.365 -2.62926 -22.9616 14.087 -8799 6 23.1803 12.6945 3.50697 -12.4047 4.12184 -0.296296 -8800 4 22.2521 12.9621 3.30307 10.5621 -3.58256 -0.535563 -8801 4 23.3663 11.8631 3.0578 -9.23841 -1.30096 -1.53094 -8802 6 37.8891 8.88353 35.4651 -18.9945 -25.3999 -47.3866 -8803 4 38.8166 8.83127 35.1934 2.77199 2.98421 7.2207 -8804 4 37.4068 8.32521 34.752 23.9265 29.6152 37.0755 -8805 6 14.3237 15.1253 36.1844 10.7536 -1.62675 -12.1114 -8806 4 15.0418 15.7291 36.3902 7.37284 -3.65767 0.0646607 -8807 4 13.765 15.154 36.9379 -17.7819 2.51157 18.8211 -8808 6 35.0801 0.941274 33.018 -10.8249 30.7834 33.3167 -8809 4 34.9269 1.883 33.2395 6.71896 -7.58638 -28.1375 -8810 4 34.9733 0.615676 33.9226 0.339269 -19.4543 -11.259 -8811 6 50.9271 0.518298 17.9933 -4.01299 -8.33658 -1.61011 -8812 4 50.7551 1.39133 17.5891 -0.713529 -12.5397 8.99793 -8813 4 50.17 41.8323 17.8017 14.8721 13.6567 -6.57092 -8814 6 26.2328 30.5636 0.934374 -8.95911 39.2037 50.9017 -8815 4 26.9657 31.1139 1.27364 -12.5333 -13.1029 -5.86431 -8816 4 26.5352 30.0815 0.207089 19.4446 -20.9762 -37.1203 -8817 6 18.5681 38.3031 4.5613 16.0408 -0.4472 -12.493 -8818 4 17.6336 38.3732 4.40187 -16.7548 5.85511 1.82222 -8819 4 18.9561 38.7121 3.75593 -0.616515 -6.35836 15.3023 -8820 6 31.1349 5.07457 4.1166 35.5071 -12.4218 -11.0008 -8821 4 31.9258 4.61163 4.53765 -37.2933 13.7034 -13.5003 -8822 4 31.2792 5.02565 3.1391 -9.10044 -1.2591 17.9933 -8823 6 26.4378 21.892 1.49191 0.117022 -23.7737 9.75083 -8824 4 26.3504 22.7277 1.07049 4.38069 30.3527 -12.7348 -8825 4 27.3618 21.6023 1.50897 -0.762137 4.81239 -9.09803 -8826 6 39.2154 11.7026 22.7855 15.1366 1.14561 24.1899 -8827 4 39.8619 11.6546 23.5153 -3.42244 7.72178 -8.31759 -8828 4 38.7922 10.855 22.8508 -11.0077 -10.6036 -7.38167 -8829 6 13.6049 36.3215 30.6697 16.8779 70.0034 -37.8159 -8830 4 13.9417 37.1302 31.1268 -10.116 -30.1168 -5.71441 -8831 4 13.4922 35.6039 31.2515 -3.36872 -19.2676 30.0327 -8832 6 50.5831 9.86782 9.34675 -39.9446 -18.2052 0.719337 -8833 4 49.679 9.5553 9.65542 27.7691 6.62521 -8.8993 -8834 4 50.7343 10.6656 9.84378 7.47556 12.1458 9.31829 -8835 6 49.6659 40.3022 22.5839 -5.95569 -23.2057 2.00246 -8836 4 49.9088 39.3695 22.3976 1.04597 17.1639 -6.42107 -8837 4 49.3089 40.2511 23.4853 9.00681 3.37443 -0.55643 -8838 6 7.21026 41.318 28.8937 -13.882 28.5523 32.2899 -8839 4 7.13277 41.6426 29.851 5.74914 -19.7174 -37.6289 -8840 4 7.14599 0.215754 28.3517 11.7183 -8.26627 3.5395 -8841 6 13.0317 18.008 25.3351 57.1177 45.3919 41.6622 -8842 4 13.702 18.0765 24.6297 -18.9881 -2.87884 -2.05071 -8843 4 13.5608 18.5052 26.1022 -41.5403 -41.2906 -37.5185 -8844 6 50.0508 19.5822 2.43378 8.05757 -12.3534 -25.4868 -8845 4 50.6415 19.2321 1.70522 -9.91294 15.3245 28.3035 -8846 4 50.4964 20.3068 2.88656 9.48594 2.0046 -2.18375 -8847 6 28.3417 40.9623 24.5247 28.1527 -9.28969 -2.11238 -8848 4 28.8808 40.6229 23.7869 -8.53201 1.00989 5.926 -8849 4 27.851 41.6822 24.1702 -24.0642 17.3603 -12.6153 -8850 6 19.4173 5.36544 29.5282 -16.7292 -1.42659 17.4998 -8851 4 20.0576 6.03033 29.2802 12.6037 1.87093 -5.71578 -8852 4 18.8017 5.84191 30.1159 0.735032 -8.12986 -7.95209 -8853 6 35.3107 40.1454 22.2712 -2.40765 19.7984 -7.699 -8854 4 35.7006 39.9699 23.1142 6.54418 -16.9762 14.0951 -8855 4 35.2702 41.1078 22.294 -0.592679 0.794763 -5.20647 -8856 6 16.1889 33.7724 9.7458 10.3229 10.2088 29.582 -8857 4 15.8959 33.2543 9.01299 -6.07516 -13.8809 -16.7379 -8858 4 15.6715 34.5759 9.82028 -7.73583 2.776 -7.11592 -8859 6 17.3675 40.6445 20.2267 0.0256395 24.2963 -9.09373 -8860 4 17.2094 39.7816 20.6122 1.5629 -5.58702 6.23448 -8861 4 17.4758 41.3298 20.9152 1.51783 -13.2527 0.49298 -8862 6 20.5171 9.72867 9.58726 35.059 7.05341 -25.1666 -8863 4 21.2226 9.96362 10.213 -13.2653 -0.810893 -5.91795 -8864 4 19.8248 9.38464 10.113 -26.7953 -13.816 19.6743 -8865 6 47.4426 20.1922 21.3765 55.2231 -18.8128 34.629 -8866 4 48.295 19.6294 21.3384 -41.3243 22.9169 -3.74061 -8867 4 46.9816 20.0754 20.5659 -14.9725 -5.50706 -31.0177 -8868 6 38.4071 40.79 37.8146 12.3234 -22.6201 -9.80787 -8869 4 38.1404 41.7017 37.8605 -3.64711 23.1989 -4.06141 -8870 4 38.2696 40.4362 38.6954 -10.1247 -0.131598 9.15413 -8871 6 4.78578 1.94641 13.1038 0.280311 5.55092 -8.42179 -8872 4 4.79931 1.2475 12.4246 2.88607 5.75183 11.0778 -8873 4 4.58324 1.57529 13.9639 -2.31824 -10.9024 4.61034 -8874 6 46.8249 29.0091 2.16845 3.76482 2.94797 40.2579 -8875 4 46.7332 29.1215 3.14399 -15.0191 0.321828 -28.5005 -8876 4 47.6691 28.5689 2.15078 10.7116 -9.65214 -17.1948 -8877 6 37.4359 26.1653 25.6478 9.30824 1.4869 -5.75173 -8878 4 37.1837 25.5346 26.3178 -5.80587 -7.25577 3.90549 -8879 4 36.6384 26.5534 25.3025 -7.59782 4.42715 -0.0787482 -8880 6 27.3269 4.19583 19.442 5.96538 17.8772 -24.7701 -8881 4 28.0114 4.58146 18.8428 -3.77368 -14.8915 15.8068 -8882 4 26.5277 4.61529 19.0816 -6.14884 -6.84507 9.70558 -8883 6 29.57 35.1706 32.6629 9.65469 -19.4491 -13.9626 -8884 4 29.5306 34.4116 32.0191 -0.1659 24.8691 21.1709 -8885 4 30.4743 35.5004 32.5856 -0.51053 -0.290213 -2.43375 -8886 6 51.6097 27.3863 34.6091 -31.2455 30.913 9.06642 -8887 4 51.929 26.6019 35 16.42 -40.5282 7.55135 -8888 4 52.0725 27.582 33.8009 7.9649 -1.59603 -13.3915 -8889 6 26.2078 15.7281 22.6941 16.538 -21.7488 31.7554 -8890 4 25.9667 16.5615 22.3191 -8.70869 23.0893 -12.8942 -8891 4 26.0629 14.9994 22.0993 -9.54979 -3.97748 -17.7982 -8892 6 36.1239 41.1986 15.4707 -7.45359 -19.8962 -4.3143 -8893 4 35.6999 40.3419 15.2987 -9.47391 11.3121 -0.409552 -8894 4 37.0386 40.9374 15.4513 15.7433 3.85103 -0.545832 -8895 6 18.465 8.81345 11.2165 5.38391 10.0618 1.17025 -8896 4 18.7987 8.15135 11.8182 8.53154 -1.35082 11.1952 -8897 4 17.7161 8.38168 10.8393 -16.7411 -2.38381 -11.2186 -8898 6 30.2088 21.3096 23.2049 -11.6688 7.62645 -9.73036 -8899 4 29.9671 22.1993 22.9248 4.97058 -0.914249 3.78278 -8900 4 29.5299 20.7541 22.7893 7.94877 -1.13118 2.47612 -8901 6 22.73 2.20521 34.8374 1.74432 -25.8699 49.3747 -8902 4 22.3572 1.29354 34.8889 6.16039 22.5731 -10.8251 -8903 4 22.7018 2.4887 33.9486 -6.75325 10.5307 -40.1895 -8904 6 12.6909 2.75059 12.3422 -14.3125 16.3183 -13.6311 -8905 4 12.533 3.61796 11.8786 11.7453 -23.2619 14.9881 -8906 4 13.1336 2.19907 11.6816 1.83842 1.45343 3.2847 -8907 6 24.107 30.0639 14.5719 -73.5796 11.8292 4.65098 -8908 4 23.699 30.7611 15.1345 32.1371 -0.343623 -0.31889 -8909 4 23.2337 29.7156 14.2286 43.085 -3.68866 -7.89372 -8910 6 0.015177 27.9048 22.8533 -2.756 -4.53229 -2.63487 -8911 4 54.6492 28.3778 23.623 -8.36257 -3.01834 -6.1652 -8912 4 54.216 27.6514 22.3224 8.23112 8.70814 10.2495 -8913 6 12.3617 4.4844 25.9108 40.9735 -25.7794 -17.3291 -8914 4 12.201 5.40791 25.8162 -22.6464 21.2272 1.21762 -8915 4 11.6198 4.00067 26.267 -15.5784 4.93476 10.9426 -8916 6 50.6578 14.4652 5.91353 -13.9437 -6.30553 43.3918 -8917 4 51.4397 15.014 5.76935 2.55266 2.90763 -3.8133 -8918 4 50.4787 14.4827 6.92851 9.15248 3.54798 -49.9389 -8919 6 52.5668 22.873 20.1428 -12.6564 -29.9263 -28.8801 -8920 4 52.956 23.3393 20.8718 4.45243 13.9606 14.107 -8921 4 52.7899 23.3428 19.3246 -0.129831 10.341 11.583 -8922 6 43.5892 16.524 12.8775 29.595 -3.78245 -19.1347 -8923 4 44.3058 16.0087 12.3806 -28.6005 27.9094 23.6723 -8924 4 42.7982 16.4888 12.3437 -11.2315 -8.54457 -10.2035 -8925 6 15.9661 16.7487 40.5866 1.44034 32.7745 -1.20572 -8926 4 16.4126 17.3388 39.9207 -12.1014 -18.8104 17.452 -8927 4 15.5985 17.3766 41.2587 12.5036 -14.614 -16.5617 -8928 6 23.4158 18.8712 23.8473 -16.0774 -11.4939 3.2157 -8929 4 23.4518 19.2692 24.728 -0.157295 3.62127 -3.85719 -8930 4 22.4941 18.9757 23.5436 12.0607 -0.266031 2.57498 -8931 6 46.4178 3.27548 31.8952 19.5415 -1.29071 -17.2416 -8932 4 45.5866 3.26999 31.4067 -8.61336 -0.166695 4.01481 -8933 4 46.2657 3.3297 32.8359 -5.35267 1.32166 2.09612 -8934 6 43.4045 41.0584 12.2875 -8.04746 -23.5947 4.76735 -8935 4 43.6693 41.8276 12.7696 6.05224 12.9314 10.8988 -8936 4 43.5172 41.2728 11.3626 0.904796 3.93503 -13.2342 -8937 6 7.4976 32.4756 29.5884 -13.7893 55.6862 -12.0377 -8938 4 8.07142 31.7837 29.8334 27.4303 -26.9633 6.13269 -8939 4 8.04212 33.3166 29.512 -13.0153 -27.2422 -1.65156 -8940 6 4.77821 31.644 22.4997 2.28771 28.4048 16.4959 -8941 4 5.27411 32.2412 23.0928 2.56389 -13.4484 -8.63656 -8942 4 4.12057 32.2584 22.1518 -1.39427 -10.0394 -7.16978 -8943 6 48.879 26.8662 2.67919 -5.86075 -60.7959 24.9619 -8944 4 49.7001 26.7095 3.23946 -26.2991 7.4186 -32.0291 -8945 4 48.3448 25.9902 2.75892 28.4546 51.6452 -6.88552 -8946 6 35.3626 23.261 21.6242 -2.7789 -2.57103 6.54281 -8947 4 36.2261 22.8974 21.81 4.94258 -15.6751 6.88864 -8948 4 35.5426 23.9136 20.9639 -1.02428 17.548 -23.8062 -8949 6 9.79934 37.7758 27.3048 16.52 16.637 17.9603 -8950 4 9.72643 38.6113 27.803 -16.1555 -8.36248 -12.7831 -8951 4 10.5885 37.4189 27.7206 -2.15823 -16.4776 -5.60851 -8952 6 6.95685 10.9812 25.9821 -25.178 -21.2877 -4.97438 -8953 4 6.33357 10.2528 25.7268 23.179 21.9129 0.503821 -8954 4 7.29095 10.6974 26.8328 9.60603 -1.481 14.6966 -8955 6 15.9965 34.4888 38.9273 -2.91878 -3.91161 19.3063 -8956 4 16.0374 33.5463 38.7461 4.95306 -0.665665 -16.4822 -8957 4 15.9715 34.4958 39.9054 -7.59103 5.72172 -22.2107 -8958 6 24.1167 17.3197 36.1615 15.3363 -47.5124 0.380375 -8959 4 24.7173 17.5753 36.8648 1.58194 5.49031 12.5141 -8960 4 24.1546 16.3101 36.2205 -9.7187 30.8811 -7.11116 -8961 6 29.9757 19.0472 5.63639 12.788 -31.6225 11.2379 -8962 4 30.1584 18.5328 6.46799 -12.7316 12.501 -21.5451 -8963 4 29.4206 19.7916 5.84051 -11.4929 16.6696 15.0892 -8964 6 41.2293 14.2018 25.873 -1.75888 28.9255 -23.3251 -8965 4 41.1078 15.0995 25.4693 3.83492 -22.0907 13.098 -8966 4 41.2654 14.3268 26.8215 3.7207 5.50516 9.94654 -8967 6 30.6006 17.7874 37.3562 -24.7598 46.8721 10.074 -8968 4 30.0173 18.4181 36.8416 23.2796 -25.9316 -1.25214 -8969 4 30.633 18.2764 38.2118 8.15578 -14.795 -8.30511 -8970 6 36.2662 35.7599 28.8527 -12.8707 -30.9202 21.2821 -8971 4 36.6718 34.9534 29.2396 -10.1595 12.442 -4.1956 -8972 4 37.0218 36.2801 28.6478 17.3511 22.2532 -11.5483 -8973 6 0.195836 37.8645 20.3851 -23.6217 6.21569 -13.9532 -8974 4 0.549498 37.2778 21.0637 4.94615 -2.95215 -2.70832 -8975 4 54.3862 37.4234 20.0075 16.4722 8.11718 6.90773 -8976 6 49.5165 39.5896 25.2714 -0.622408 -34.3922 32.9891 -8977 4 49.1772 39.7667 26.1925 10.9208 -1.11318 -32.3029 -8978 4 49.8261 38.6352 25.2806 -10.9036 35.658 1.81375 -8979 6 21.6574 10.1952 29.3538 -5.06277 -0.743802 10.2318 -8980 4 21.4664 11.1105 29.223 -3.01111 19.5458 -20.3057 -8981 4 21.662 10.2064 30.3052 9.73006 -17.7161 13.8831 -8982 6 36.4636 30.0567 0.119709 9.37859 61.6807 38.5429 -8983 4 36.3123 29.4684 41.3206 -1.21017 -23.1836 -37.505 -8984 4 36.9143 30.908 41.7057 -13.4567 -39.5067 4.20368 -8985 6 35.2344 23.3726 39.1433 31.8417 -88.9919 -51.9106 -8986 4 35.0278 23.5012 38.2069 -5.96056 -5.38998 8.96032 -8987 4 34.9909 24.127 39.538 -31.8308 96.9265 45.0865 -8988 6 25.4761 17.6258 38.7257 1.29934 8.28965 -16.1346 -8989 4 26.2031 17.0769 39.0234 13.7946 -6.33455 1.86524 -8990 4 25.7107 18.4933 39.0598 1.3782 7.33891 4.86011 -8991 6 32.6846 1.71002 15.3734 -11.6254 -20.3205 21.5399 -8992 4 32.9453 1.93093 16.3086 -8.96834 -8.53877 -20.2534 -8993 4 32.154 0.853232 15.3925 19.204 32.1949 4.36426 -8994 6 2.7574 26.2382 40.1716 -4.40087 -21.6692 -50.7652 -8995 4 2.38718 26.7949 40.8139 -8.13358 26.7101 38.7547 -8996 4 3.41358 25.6429 40.5298 13.0891 -5.49009 7.80053 -8997 6 25.4307 39.5752 6.64887 -26.4755 -1.32722 14.1102 -8998 4 25.8932 39.0809 7.30961 27.038 -6.17916 -3.25304 -8999 4 24.5458 39.4465 7.03066 -2.44587 12.932 -21.9634 -9000 6 3.88975 2.45855 21.1879 28.3389 -91.355 -25.6726 -9001 4 3.44478 1.54109 20.9736 25.4092 48.4753 9.01111 -9002 4 3.19228 2.99847 21.4284 -47.2055 43.8768 12.3888 -9003 6 19.4353 35.9908 6.17834 -1.98144 -11.1023 18.0698 -9004 4 18.7425 35.7628 6.83514 2.39623 12.5316 -16.1317 -9005 4 19.0828 36.5127 5.45195 -11.0597 11.4176 1.1294 -9006 6 53.664 10.8386 34.7899 -0.427116 -3.27611 41.7292 -9007 4 53.6105 10.6836 35.7561 -1.66612 -17.5448 -26.7849 -9008 4 53.9652 11.7272 34.8329 4.68725 29.9217 -18.2793 -9009 6 51.2799 14.0867 34.6651 -29.2798 -10.9719 -23.3019 -9010 4 50.6522 13.5411 34.1107 26.8684 18.9114 5.01949 -9011 4 50.9895 13.8814 35.5479 1.81167 -5.08277 17.6681 -9012 6 14.4338 40.0198 28.0288 -0.147098 23.5255 27.6002 -9013 4 13.7688 39.3521 27.8218 1.28331 -8.25373 7.75106 -9014 4 14.1948 40.5222 28.8704 -0.878391 -19.6822 -29.209 -9015 6 36.0552 40.8569 1.29319 48.4065 13.1893 15.2608 -9016 4 35.4421 41.0883 1.96787 -21.4185 -0.412662 13.5205 -9017 4 36.896 41.2683 1.66088 -27.5471 -12.7345 -18.5843 -9018 6 32.5846 21.8706 9.62772 14.4951 6.80277 0.680584 -9019 4 32.1936 21.3098 8.97285 -7.2875 -23.9506 -7.81502 -9020 4 32.858 22.6104 9.08324 0.955029 10.0343 1.40437 -9021 6 53.7602 11.4574 10.0748 -7.70253 -4.89045 -17.0247 -9022 4 54.6558 11.7035 10.3272 3.70339 -10.2166 -5.16833 -9023 4 53.8328 10.8374 9.31644 -2.27357 5.83713 13.9933 -9024 6 25.443 2.0669 35.0212 -16.7533 17.7231 -21.4763 -9025 4 25.6415 2.91576 34.5502 -7.64634 -16.7974 11.4347 -9026 4 24.4652 2.09352 35.1703 17.3945 -2.11295 -4.26167 -9027 6 38.4088 16.3775 27.0777 23.4896 -26.556 7.92078 -9028 4 38.4029 15.905 27.9411 -0.72651 18.7119 -5.4255 -9029 4 38.1233 17.2789 27.1678 -4.67214 15.3602 11.0072 -9030 6 11.9834 11.8283 38.0863 1.50515 -20.9897 -19.5245 -9031 4 12.337 12.445 38.7318 -5.05033 4.06408 7.46746 -9032 4 11.0493 11.6049 38.244 7.06215 11.5652 6.68382 -9033 6 21.1646 40.7247 25.8949 30.8575 -6.32012 -20.5276 -9034 4 20.7152 41.4784 25.5554 -14.4662 20.9939 -18.0031 -9035 4 20.8194 40.6451 26.758 -13.9443 -15.9826 36.5019 -9036 6 5.45737 31.2526 28.1092 12.1805 15.5126 -2.48606 -9037 4 4.77986 31.7446 27.6301 0.776808 -0.764161 -8.53258 -9038 4 6.21204 31.8695 28.2031 -7.61365 -6.18966 7.74582 -9039 6 38.5666 10.4345 26.6322 12.4833 -8.23035 1.5222 -9040 4 39.2815 10.9281 26.2104 -2.91177 1.8082 -0.00903947 -9041 4 39.0293 9.89744 27.2937 -7.88948 5.75886 -1.98766 -9042 6 34.5704 22.2441 5.77364 -5.35359 -6.12765 6.5276 -9043 4 33.6261 22.329 6.01336 10.9983 8.59631 1.2651 -9044 4 35.1361 22.6291 6.46875 -10.1328 -5.43064 -4.61746 -9045 6 19.508 23.4157 8.91293 -5.78488 4.73981 5.04963 -9046 4 19.7274 23.1974 9.83518 1.16663 -6.94775 -9.92836 -9047 4 19.9131 22.8043 8.29809 9.12387 -6.1547 2.91491 -9048 6 19.7424 39.1606 18.9462 6.36032 12.2479 8.14591 -9049 4 20.3561 39.0422 19.6872 -3.85164 -4.35394 -5.20149 -9050 4 19.0738 39.7495 19.3414 -1.06489 -8.07777 -11.9442 -9051 6 19.0057 16.6591 37.8853 37.3334 -16.7993 4.17439 -9052 4 18.1861 16.4809 37.4823 -32.8062 -2.38488 -19.1553 -9053 4 18.8146 17.2984 38.5514 -2.10283 15.4454 14.1988 -9054 6 46.1541 18.3125 34.4675 -16.9871 7.29415 15.254 -9055 4 46.1595 17.7325 33.7168 0.615393 -10.1859 -17.2384 -9056 4 45.2376 18.6499 34.5058 9.28079 -5.03019 -2.85447 -9057 6 37.6537 4.93165 10.635 20.1552 -8.04423 -16.7256 -9058 4 38.5399 5.21744 10.272 -26.6503 -7.30776 7.98139 -9059 4 37.1074 4.55852 9.88971 22.9932 21.6332 27.1334 -9060 6 51.9792 36.004 6.8478 30.791 3.18545 -0.726681 -9061 4 52.2413 36.7963 6.35992 -14.9215 -4.55469 -2.53046 -9062 4 52.8266 35.8818 7.33626 -22.3254 6.63746 5.40006 -9063 6 26.6741 12.3268 1.0034 -10.7024 -25.4666 -34.2692 -9064 4 26.4988 12.3574 1.94138 -4.81655 1.43394 14.8604 -9065 4 26.0954 11.585 0.663483 16.9242 17.5219 15.4646 -9066 6 51.3423 35.7724 13.5298 -0.266216 29.5034 10.6004 -9067 4 51.4043 36.4131 12.804 2.34884 -4.4098 -1.45811 -9068 4 51.4073 34.9167 13.1542 5.41074 -27.2154 -15.541 -9069 6 1.98873 3.64285 24.5869 25.9971 69.8048 -55.2188 -9070 4 1.65752 3.03018 25.1632 -30.3002 -46.9535 54.3289 -9071 4 1.71436 4.54846 24.8879 2.6309 -26.2008 -0.982747 -9072 6 33.5221 15.2795 16.4506 0.0536135 -15.838 -38.1617 -9073 4 33.6476 15.3964 15.4593 -8.63578 3.82522 35.1416 -9074 4 33.7341 16.1085 16.8736 8.85342 14.4801 4.37501 -9075 6 10.7227 26.5775 37.3442 -67.903 54.2831 -20.645 -9076 4 10.2191 27.0779 38.0369 14.5194 -13.2702 -3.80745 -9077 4 11.4784 26.2608 37.7268 68.0232 -30.094 41.6962 -9078 6 39.6271 8.38119 31.999 1.44949 -5.13238 35.1009 -9079 4 39.1996 8.85287 32.7464 5.61163 -5.5592 -21.3265 -9080 4 39.0885 8.45634 31.2221 -15.3514 9.3045 -12.0182 -9081 6 48.873 24.2439 11.5987 1.10357 -37.2725 -9.21005 -9082 4 49.1825 23.3167 11.4023 -5.65288 27.9965 8.32055 -9083 4 49.5986 24.6511 12.0826 3.19491 3.15896 -2.50749 -9084 6 15.8098 8.51994 22.5326 -12.5814 0.672941 2.19285 -9085 4 15.7588 8.52265 21.5683 10.3815 2.49136 4.36748 -9086 4 15.4206 9.36801 22.7863 6.5895 4.65597 -0.371293 -9087 6 16.9392 23.5364 7.95083 25.1749 21.5498 -34.0775 -9088 4 17.2079 23.9031 7.093 -25.8979 -5.01679 3.50755 -9089 4 17.8126 23.4623 8.29573 16.7216 -7.09478 32.6865 -9090 6 42.4825 26.8555 6.33102 0.60087 7.54144 -12.7632 -9091 4 41.764 27.4892 6.46083 9.75026 1.01062 3.5184 -9092 4 43.14 27.3488 5.78659 -9.42643 -3.33158 7.6404 -9093 6 36.8078 4.79995 30.0438 -4.74249 18.2042 -3.85385 -9094 4 36.952 4.89746 30.9922 3.10706 -1.8894 0.559973 -9095 4 36.294 4.02131 29.8808 -10.4691 -15.4659 3.71438 -9096 6 45.6128 11.6142 3.31163 15.5246 21.1623 13.6733 -9097 4 45.8972 10.701 3.31117 0.727629 -14.3179 7.30305 -9098 4 46.2501 12.0834 3.90994 -13.3278 -10.7206 -15.6492 -9099 6 24.8943 36.3842 21.2731 0.145584 -0.0155718 21.9832 -9100 4 24.5073 36.3627 22.1568 -5.92138 3.86098 -2.91089 -9101 4 25.79 36.6624 21.4916 7.30899 1.2523 -13.3669 -9102 6 31.8172 24.7218 2.44079 24.9542 32.077 -0.738567 -9103 4 31.5948 23.8911 2.82575 -7.26237 -24.1795 3.52598 -9104 4 32.7966 24.7848 2.51706 -20.2581 -1.29655 -5.98664 -9105 6 24.135 21.9795 37.225 -18.6422 57.7065 19.5247 -9106 4 24.1223 22.9841 37.1061 1.06209 -41.2434 9.50937 -9107 4 24.7129 21.6948 36.5371 13.1815 -12.7877 -24.1492 -9108 6 37.1979 11.5342 15.06 20.8972 -17.7328 -40.5152 -9109 4 38.0246 11.7972 15.4709 -1.33045 5.21986 19.7962 -9110 4 36.429 11.9138 15.4438 -18.178 22.6449 25.793 -9111 6 36.4751 20.3399 41.7845 -26.5497 -48.0551 41.2862 -9112 4 36.3228 19.4621 41.3748 1.60744 11.8178 -3.29004 -9113 4 36.9246 20.873 41.191 27.5593 28.4699 -43.2619 -9114 6 32.0497 37.9214 32.6612 -32.2386 -8.50634 -18.7459 -9115 4 32.4337 38.7163 32.9803 20.8647 20.5609 12.2985 -9116 4 31.3654 38.2694 32.0613 5.31663 -14.2519 5.69849 -9117 6 12.0395 39.928 22.5123 -26.9832 36.7812 23.3187 -9118 4 12.2839 40.8414 22.1926 -3.01474 -29.6796 4.86816 -9119 4 11.2932 40.0883 23.1662 29.524 -10.585 -25.0576 -9120 6 26.3406 1.33526 19.2893 15.6729 -20.8034 13.8388 -9121 4 26.8411 0.655996 19.8199 -14.5491 24.9752 -14.9066 -9122 4 26.8003 2.1813 19.3861 0.112049 0.00336314 -1.02908 -9123 6 5.91669 14.3164 5.69097 2.29729 -16.5161 -30.3395 -9124 4 6.30102 14.1024 4.7902 -6.32478 5.25084 23.5077 -9125 4 5.06552 13.8494 5.70115 7.33482 -6.30923 1.55114 -9126 6 13.3703 23.089 19.1627 -28.3895 15.3871 14.4757 -9127 4 14.1086 22.8122 18.6632 27.2898 -8.01563 -16.6587 -9128 4 13.6991 23.742 19.8005 3.67942 -13.964 0.879599 -9129 6 23.4058 15.0688 9.73621 -4.11719 1.06855 12.2005 -9130 4 22.5732 14.661 10.02 0.657405 4.9462 -7.25364 -9131 4 23.2196 15.7347 9.05868 -5.70535 0.38861 -5.0655 -9132 6 49.5812 13.8288 18.4474 0.101153 1.0527 41.008 -9133 4 48.8214 13.4814 17.9923 -8.96247 -7.71084 -15.1851 -9134 4 50.2052 14.1722 17.8367 10.7879 13.5653 -33.2962 -9135 6 41.7444 5.67096 41.8915 25.5819 0.859229 17.1787 -9136 4 42.5704 5.9364 0.475256 -21.6624 -6.74737 -14.5764 -9137 4 42.0361 4.9893 41.2645 -5.04703 6.59959 -2.77397 -9138 6 17.2492 35.5437 2.55512 -4.98919 17.2489 6.23124 -9139 4 18.1963 35.629 2.41282 7.59523 -3.20753 1.41995 -9140 4 16.9663 34.6563 2.38439 4.57262 -16.6324 -5.73806 -9141 6 49.6936 19.8647 40.242 36.1149 -8.05295 1.41344 -9142 4 49.24 19.0314 40.466 10.1916 2.45634 3.62304 -9143 4 50.6901 19.7225 40.3055 -34.6505 -2.12616 -4.55887 -9144 6 38.3055 5.83107 32.0437 -25.1209 3.13983 17.5072 -9145 4 37.8566 6.51058 32.5952 5.57321 -12.5864 -8.78808 -9146 4 39.2068 6.11217 32.0045 20.6085 6.27671 -1.8315 -9147 6 16.2656 6.85278 34.0134 13.6308 -7.44031 -0.955967 -9148 4 16.5278 6.7006 33.1016 -0.686465 1.61317 -6.98637 -9149 4 17.0706 6.57794 34.496 -11.7464 5.49098 9.02554 -9150 6 33.6779 18.1919 10.4599 39.833 -25.9405 -6.08719 -9151 4 34.2274 18.843 9.984 -7.48822 -11.4027 6.26591 -9152 4 34.2403 17.3374 10.5556 -30.6671 44.9369 -7.76686 -9153 6 38.8896 33.7563 36.7672 22.7659 10.9801 -36.8997 -9154 4 38.4264 33.5452 35.9055 8.66825 7.19978 21.2858 -9155 4 39.8358 34.0039 36.5278 -27.7603 -15.0244 3.77145 -9156 6 45.3747 13.0912 20.2115 -8.54575 18.1695 38.2532 -9157 4 45.1986 12.6554 19.3957 -4.2418 -14.8759 -23.2281 -9158 4 44.5273 13.1029 20.6991 7.89471 -4.73094 -13.0554 -9159 6 36.3919 32.2126 8.83938 1.15121 -2.28434 -1.4136 -9160 4 36.3207 31.3933 9.34391 1.93757 3.36082 7.91897 -9161 4 36.0586 32.9456 9.38554 -3.10773 -8.06217 -4.51958 -9162 6 7.93399 27.8164 6.18652 -8.84441 8.26416 -30.5327 -9163 4 8.20753 27.2416 6.88401 9.15323 -7.03573 14.7081 -9164 4 8.30192 28.6748 6.41842 -5.04409 0.971707 0.751098 -9165 6 14.2889 4.87494 33.6812 -48.074 -5.72289 -27.637 -9166 4 13.5426 5.15568 33.0467 38.2298 -5.02982 23.8683 -9167 4 14.8103 5.65434 33.8518 10.0815 16.0504 2.39638 -9168 6 12.247 8.64363 9.86387 9.5307 8.47707 -42.9656 -9169 4 12.7265 8.83196 10.6522 4.83417 -1.95201 32.3898 -9170 4 11.3733 8.28369 10.003 -7.27928 -7.56138 14.4849 -9171 6 29.7193 31.982 8.5339 -11.3757 5.45371 -22.6092 -9172 4 30.2272 31.7973 9.28681 18.5431 -1.21859 37.4341 -9173 4 29.7513 31.1489 8.05875 -9.95983 -0.182644 -6.87416 -9174 6 22.3912 10.8818 21.4749 22.6973 -30.3469 0.856054 -9175 4 21.7953 11.1177 20.7819 -19.5872 13.8984 -18.5017 -9176 4 22.3568 11.5583 22.1363 -13.7305 16.7548 8.89642 -9177 6 54.1825 27.5382 12.9949 16.0749 -34.873 29.2784 -9178 4 0.169556 27.5337 13.075 -9.84187 5.32432 -2.29215 -9179 4 53.8855 28.25 12.4714 -3.97587 36.1158 -26.3516 -9180 6 7.7322 13.8127 20.037 -51.4252 10.19 -38.2554 -9181 4 8.32211 14.101 20.6974 26.6579 16.8549 28.1402 -9182 4 7.28001 14.6396 19.6917 19.816 -24.9044 7.79538 -9183 6 19.8038 0.841082 24.7751 2.23798 25.7663 18.7115 -9184 4 19.2888 0.974936 25.5977 -1.44078 2.26272 -14.328 -9185 4 20.345 1.66892 24.688 -12.1486 -28.8133 2.35345 -9186 6 3.00622 10.0987 2.94957 -26.3714 23.4248 -9.90714 -9187 4 2.57802 10.9845 2.80681 8.85648 -28.8297 5.38 -9188 4 3.90714 10.2978 3.18407 20.8138 3.7803 5.2 -9189 6 15.8735 13.0135 24.0167 27.3456 -6.4848 -7.35342 -9190 4 15.0397 13.4574 24.067 -14.2007 12.8972 1.61729 -9191 4 16.3075 13.2711 24.8409 -0.511489 -7.63656 -0.0548578 -9192 6 17.0843 4.34635 26.9246 21.6007 -4.50946 14.2865 -9193 4 16.8972 4.2188 26.0046 2.50265 0.324122 -20.691 -9194 4 18.0611 4.2338 26.9976 -18.2314 5.96709 -0.11875 -9195 6 33.6189 39.4094 10.6341 -20.462 51.0085 -28.6484 -9196 4 33.9391 38.663 11.0702 20.9333 -51.253 8.17882 -9197 4 33.8334 39.409 9.67256 -1.15733 -4.02232 18.0774 -9198 6 36.2391 1.10544 13.1071 -14.4853 9.25302 -40.2412 -9199 4 35.5849 0.422507 13.2928 -0.138393 -8.38057 10.5121 -9200 4 36.8138 1.26142 13.8363 9.41155 -3.27129 23.8008 -9201 6 40.853 19.2974 5.10856 37.2457 -28.9827 71.4026 -9202 4 40.5429 19.587 4.3016 -40.6732 16.7295 -57.0845 -9203 4 40.1307 19.0416 5.7147 0.644924 10.2678 -10.4268 -9204 6 2.34714 37.5568 10.1845 35.9634 7.02123 17.8242 -9205 4 3.04769 37.1203 10.7322 -14.847 6.26565 -12.1612 -9206 4 1.86424 36.8893 9.71962 -14.8151 -24.6966 -11.8987 -9207 6 8.10127 29.0413 15.8656 35.302 -29.7249 12.8686 -9208 4 9.00843 28.6191 15.9508 -31.5464 15.4715 -14.0583 -9209 4 8.16404 29.7921 16.4466 -1.11054 13.1495 4.82257 -9210 6 47.3142 26.5199 12.5393 12.6514 34.6971 -22.5506 -9211 4 47.5805 27.2834 11.915 -17.373 -39.4708 28.4474 -9212 4 47.3752 25.7188 12.0092 -0.907674 -0.00416251 -5.94845 -9213 6 33.5917 17.5154 0.659811 -43.6991 -50.8046 22.4668 -9214 4 32.6165 17.4611 0.916402 33.9721 22.4374 -10.1482 -9215 4 33.8023 16.5556 0.790839 15.7196 25.0769 -8.55135 -9216 6 38.9785 15.6005 36.3846 -2.2974 -5.19358 -9.56289 -9217 4 39.1604 14.6481 36.4599 -0.972636 7.263 -3.41001 -9218 4 39.314 15.9159 35.5329 5.29716 -3.31476 -2.44888 -9219 6 34.8185 34.3512 9.36223 6.47638 -43.1481 -28.0847 -9220 4 35.4473 34.9875 9.0418 9.26483 22.2324 -9.2882 -9221 4 34.4241 34.6992 10.1221 -17.9819 29.7233 40.2724 -9222 6 44.963 2.56985 14.7807 31.4374 15.1132 5.36654 -9223 4 44.0324 2.49792 14.9225 -24.9873 -3.38313 6.1219 -9224 4 45.264 3.39221 15.2058 -8.16761 -2.00961 -7.57881 -9225 6 42.6004 38.2794 19.8329 35.0217 22.8895 -33.2683 -9226 4 42.7468 39.1886 19.4383 -9.39889 -30.5105 9.50416 -9227 4 43.174 37.7101 19.2395 -23.2435 10.9907 19.5876 -9228 6 18.6884 26.768 30.2631 -44.5574 -6.69712 -17.565 -9229 4 18.1049 26.7773 29.4546 19.8507 -1.43152 25.0232 -9230 4 19.5658 26.9377 29.9555 24.8572 5.14496 -8.76909 -9231 6 38.8622 37.7231 16.4658 -22.8479 4.5656 13.1257 -9232 4 38.7902 36.7734 16.2818 1.44729 8.74588 -1.32739 -9233 4 39.7766 37.9619 16.5567 26.2519 -3.67716 3.06508 -9234 6 49.2941 9.82087 12.5338 42.2108 35.2088 45.7943 -9235 4 48.9089 9.29765 11.888 -36.0338 -29.0733 -40.4243 -9236 4 48.6148 10.195 13.1058 -6.01968 0.395602 -5.44143 -9237 6 43.2224 7.37144 19.82 -8.13737 3.26926 23.5272 -9238 4 42.5007 7.77471 20.3735 21.5488 -7.79487 -11.5807 -9239 4 44.0862 7.49788 20.2643 -6.92785 0.102081 -4.68832 -9240 6 36.344 38.7219 4.42923 6.60518 -8.27287 -3.54737 -9241 4 36.8681 39.515 4.62823 -9.591 -1.38231 4.53716 -9242 4 35.4251 38.8858 4.67742 1.90858 4.69501 2.45497 -9243 6 27.7906 17.7903 15.1063 3.75124 -7.8529 -14.6222 -9244 4 27.6041 16.8818 14.7764 0.112743 20.8749 5.00331 -9245 4 27.89 17.7299 16.0573 -1.67078 -3.69001 6.73869 -9246 6 18.0934 3.7697 37.3166 -37.4896 -7.94699 -19.9181 -9247 4 18.6099 3.0373 36.9676 7.8944 1.98274 4.30106 -9248 4 18.6508 4.23334 37.9126 25.9725 10.5984 22.5053 -9249 6 7.70643 11.5866 6.5218 3.89219 -35.3855 26.5153 -9250 4 7.81247 12.3986 6.99593 -0.830342 19.7116 4.35361 -9251 4 7.69429 11.7375 5.59555 -1.18048 8.56411 -33.1609 -9252 6 31.493 14.3493 18.0362 -8.33789 -14.4781 24.6772 -9253 4 32.1359 14.6991 17.4236 11.1505 2.18599 -11.6706 -9254 4 31.9992 13.8221 18.6877 -1.72215 8.99473 -5.41338 -9255 6 50.3257 30.4119 8.91981 13.6638 2.66477 0.921327 -9256 4 49.6699 30.7962 8.33415 -6.09837 5.9585 -1.44957 -9257 4 50.0726 29.5063 9.09532 -3.6785 -2.74239 1.52637 -9258 6 42.1666 10.1001 12.7665 27.8846 0.568566 -7.78474 -9259 4 41.2574 9.89168 12.6212 -25.0269 -7.71108 -1.23548 -9260 4 42.2044 10.927 13.2385 -4.76175 6.29789 8.61568 -9261 6 37.7726 3.10257 32.5651 17.7286 -33.908 -11.3576 -9262 4 38.1655 3.96622 32.6549 -5.80606 19.6252 0.391082 -9263 4 36.8286 3.11418 32.7073 -14.5698 15.7581 5.48125 -9264 6 35.7529 13.1025 19.269 15.6222 -22.7979 5.95892 -9265 4 36.108 13.8438 19.7616 3.89933 6.86159 4.70877 -9266 4 36.3275 12.3403 19.5267 -16.9537 12.3267 -5.61016 -9267 6 45.5307 4.12701 21.4866 3.53751 -14.4086 10.8893 -9268 4 45.552 4.15257 20.5178 1.20389 1.85135 1.62688 -9269 4 45.7304 3.20168 21.7391 -1.66454 15.9633 -13.005 -9270 6 16.8818 1.84763 31.4809 -38.7514 34.7723 -17.791 -9271 4 16.1373 2.3559 31.0688 16.7124 -32.2776 -3.52377 -9272 4 16.9707 2.38347 32.2636 22.4894 -8.71684 18.7287 -9273 6 14.088 4.88632 23.5804 12.6338 -46.5447 -4.7054 -9274 4 13.8705 5.7909 23.7155 -14.7558 31.001 11.1078 -9275 4 13.7332 4.31383 24.2952 -4.17517 18.1368 -8.36436 -9276 6 38.3179 33.7515 12.3711 -25.6361 -5.15185 -28.4625 -9277 4 38.1256 32.9508 11.8227 6.04426 17.9062 13.2724 -9278 4 39.1779 33.654 12.756 21.0695 -5.21903 12.1581 -9279 6 35.6902 3.04562 37.6746 -3.39904 8.35156 -7.25132 -9280 4 35.0929 2.54933 38.2324 -5.1037 -10.0227 3.00486 -9281 4 35.8394 3.86187 38.1597 5.81883 9.20211 1.39187 -9282 6 31.3375 37.3986 35.3773 -3.71028 -11.6357 31.0668 -9283 4 32.2621 37.6229 35.4422 12.7398 8.80293 9.59752 -9284 4 31.1956 37.5429 34.4696 -8.56261 0.879722 -41.7472 -9285 6 52.0699 11.7425 14.0188 13.7235 -2.71131 -30.9774 -9286 4 51.8967 11.0942 13.2788 12.7756 18.36 20.3091 -9287 4 52.777 12.3878 13.7226 -29.9657 -23.6346 9.26958 -9288 6 26.3494 3.44143 41.0133 25.155 -37.875 16.6614 -9289 4 25.5593 3.94137 41.1232 -17.1598 23.2709 -17.7277 -9290 4 26.8278 3.58917 40.1822 -8.59815 12.7626 -4.44352 -9291 6 24.371 34.9599 11.1571 26.4033 32.6711 -2.50587 -9292 4 24.3639 34.5741 12.011 0.42503 -6.32387 38.1824 -9293 4 23.9976 34.2869 10.6415 -25.866 -31.4028 -29.8537 -9294 6 32.0031 7.59722 31.2247 -0.72006 7.33901 18.8157 -9295 4 32.1508 7.36357 30.327 0.345644 0.817488 -27.7554 -9296 4 31.6126 8.48818 31.2118 -2.13527 -8.40442 2.30992 -9297 6 28.7291 2.6069 0.424694 -24.9548 -1.7826 -18.2237 -9298 4 29.2265 2.34055 41.548 2.55638 3.32464 9.52498 -9299 4 27.7798 2.59721 0.142899 25.7986 3.33204 9.63582 -9300 6 42.1267 19.2107 9.86358 19.9254 -1.00598 31.807 -9301 4 42.7282 19.2504 10.675 -28.0191 -3.63038 -32.4782 -9302 4 41.4654 18.506 9.99331 2.41107 5.70909 -2.24499 -9303 6 33.0117 27.0899 8.33041 6.96541 -9.8522 -22.9567 -9304 4 33.8754 26.9804 7.88875 -4.89246 2.6856 6.68054 -9305 4 33.1889 27.2976 9.23992 7.88062 7.04275 14.0068 -9306 6 4.17016 8.31297 19.162 0.312608 -23.727 -31.8356 -9307 4 4.57057 7.90515 18.3575 7.98956 13.418 22.158 -9308 4 3.24181 8.25888 18.9046 -6.31749 7.79174 9.16769 -9309 6 20.797 29.1851 37.0682 -78.8245 -16.0462 -5.4556 -9310 4 20.936 28.2326 36.9784 16.4861 -0.723813 3.66436 -9311 4 21.5674 29.6886 37.0761 54.0195 18.5923 4.39527 -9312 6 13.113 4.99943 10.9253 0.843453 12.9862 -7.21248 -9313 4 13.3812 5.91092 11.1622 0.48683 -16.0572 0.936043 -9314 4 12.7752 5.03128 10.0238 -4.21215 6.55392 -0.64752 -9315 6 37.5015 18.1018 32.5195 21.2703 25.6519 14.9603 -9316 4 38.1786 18.7738 32.2234 -25.3038 -17.5123 8.13315 -9317 4 37.1867 18.4103 33.3985 6.70568 -0.056708 -13.7279 -9318 6 17.7491 33.2689 30.7387 4.64458 14.8517 -20.1826 -9319 4 17.8421 33.9996 30.1068 1.39741 -2.79987 6.34018 -9320 4 18.5541 33.2627 31.2599 6.50121 5.74528 2.59283 -9321 6 23.1871 32.777 9.90494 7.13269 10.4795 -4.3903 -9322 4 23.4604 31.94 10.2921 1.41378 -5.3263 0.807867 -9323 4 22.2339 32.7251 9.74224 0.938735 -0.283076 -0.953242 -9324 6 14.8916 9.36878 34.2544 -3.17606 -9.25219 -4.09189 -9325 4 15.4257 8.57154 34.1751 4.23415 -4.52565 -0.814207 -9326 4 15.1936 9.94604 33.5417 3.33837 13.7034 4.88209 -9327 6 31.123 39.3556 38.5725 10.4581 -15.7875 9.507 -9328 4 31.6408 38.6334 39.0195 -17.0405 19.4438 -10.5616 -9329 4 30.3963 38.9123 38.1137 2.26745 0.847431 0.999129 -9330 6 5.28935 34.441 28.2777 -1.85934 -10.7383 -20.8922 -9331 4 5.27738 35.3973 28.3959 -1.64374 -0.931958 4.82044 -9332 4 5.15855 34.3195 27.3212 3.56171 0.206479 13.9304 -9333 6 30.3161 21.6889 14.1169 -2.08187 28.5408 26.4102 -9334 4 30.4824 20.7856 14.3415 3.20532 -20.0191 -7.60805 -9335 4 30.3589 21.8902 13.1869 1.55029 -10.1196 -17.5522 -9336 6 23.85 39.0046 28.2977 69.4329 26.2515 4.57453 -9337 4 23.9916 39.6084 27.5499 -13.57 2.08121 2.63988 -9338 4 23.036 38.5875 28.2612 -60.5143 -23.8938 -11.8576 -9339 6 9.59742 13.5396 16.4589 33.261 19.9292 -8.86772 -9340 4 8.78625 13.0496 16.3926 -14.9619 -4.96746 -5.567 -9341 4 9.78335 13.9533 15.5888 -9.09133 -14.4247 9.50074 -9342 6 25.9705 6.17968 15.7985 42.799 -23.1477 28.9675 -9343 4 26.019 6.01901 14.8637 -2.75181 4.35539 -17.3872 -9344 4 26.7603 5.64791 16.135 -36.9143 25.7793 -10.0513 -9345 6 15.9952 33.6108 22.5498 -1.32684 21.179 0.174096 -9346 4 16.0845 34.132 21.7265 -5.08009 -17.3545 9.33233 -9347 4 16.0452 32.6693 22.2946 2.44519 21.8582 -2.86748 -9348 6 40.6954 13.5457 12.1293 -5.68603 3.79069 10.9638 -9349 4 40.3939 13.0592 11.3555 -1.07855 -14.0058 -3.54454 -9350 4 41.0539 12.9031 12.7626 -3.06611 3.62129 -5.67307 -9351 6 35.5822 40.2773 31.6862 -1.2862 -13.706 14.6905 -9352 4 36.0451 40.9783 31.2154 -1.32327 -4.34646 -14.1397 -9353 4 35.653 39.3915 31.2603 0.648621 22.1552 -3.29488 -9354 6 19.3539 17.5757 17.8527 24.8545 64.4629 -5.36553 -9355 4 19.9703 18.4106 17.9379 -31.776 -45.1138 0.798127 -9356 4 18.7059 17.8424 17.1823 2.41282 -7.28307 3.58563 -9357 6 7.95249 28.0742 10.7793 26.3782 25.043 4.49745 -9358 4 8.50313 28.8396 11.0908 -15.1612 -19.5627 1.83511 -9359 4 7.20779 28.4792 10.322 -5.34026 -2.34355 -4.06419 -9360 6 32.1473 39.5951 16.6478 -17.9563 1.55165 -8.91142 -9361 4 31.6569 40.3908 16.3404 14.2892 -12.9666 6.03874 -9362 4 31.5266 38.8716 16.4637 6.06753 4.48602 8.64925 -9363 6 35.7883 2.63292 18.1275 9.48574 -34.9606 14.0071 -9364 4 34.8666 2.32593 18.1793 13.7366 6.70894 -2.41967 -9365 4 35.7792 3.51083 17.8116 -6.62646 29.9084 -15.3578 -9366 6 14.9404 39.9496 36.887 -3.95865 -34.2615 35.0372 -9367 4 15.4649 39.4425 36.2826 11.0028 -6.45738 -16.6057 -9368 4 15.0284 40.8419 36.6608 5.56286 51.7396 -15.8162 -9369 6 18.3052 32.4025 11.469 7.68428 8.43447 19.219 -9370 4 18.6311 32.5236 12.4045 -8.3236 -1.07971 -30.5152 -9371 4 17.8613 33.2392 11.223 7.02035 -14.738 0.639166 -9372 6 14.6021 10.381 5.00501 12.904 -5.64335 9.41677 -9373 4 13.6938 10.4305 4.69945 -10.3065 0.63937 1.1744 -9374 4 14.613 10.0418 5.92181 -1.23128 6.20644 -15.3767 -9375 6 2.02771 14.3355 39.1727 -5.84559 30.0988 4.34298 -9376 4 2.70173 15.0418 39.0898 -4.78946 -14.8923 5.30178 -9377 4 1.28797 14.7602 39.6738 10.0694 -17.377 -15.1558 -9378 6 7.58332 14.1556 32.4652 3.8824 27.7869 10.7592 -9379 4 6.9433 13.665 32.9756 -4.43494 -6.18284 1.69377 -9380 4 7.54129 15.0698 32.8492 6.23928 -24.1467 -15.6449 -9381 6 6.15722 23.1341 37.6504 -34.5618 -50.1938 -2.0692 -9382 4 6.56488 23.96 37.7745 13.4151 41.4847 -0.267706 -9383 4 5.38195 23.2242 37.0516 20.9526 5.02196 8.70483 -9384 6 37.2952 22.537 4.44472 51.3933 75.9823 3.75371 -9385 4 36.5074 22.1342 4.18978 -47.7056 -22.8011 -17.3868 -9386 4 37.221 23.5361 4.21623 -3.53185 -51.7458 12.1203 -9387 6 47.1368 31.0168 5.89375 -14.3926 17.1884 -69.1718 -9388 4 46.9718 30.7968 6.77028 -10.6218 -7.91998 56.0799 -9389 4 46.2684 31.351 5.53353 23.0456 -16.9797 4.17914 -9390 6 54.8109 25.5937 34.9376 16.0179 27.3393 -6.0446 -9391 4 54.0726 25.4665 35.5517 -1.08617 7.29827 -2.61058 -9392 4 0.161491 26.54 35.0366 -21.9365 -36.0956 3.57937 -9393 6 37.1499 2.07739 4.80452 -1.94348 22.0087 -45.3652 -9394 4 36.668 2.89852 4.54683 5.06511 -19.4283 11.9563 -9395 4 37.1062 1.96831 5.73813 -4.74438 -1.19387 27.2393 -9396 6 22.5142 28.609 8.91066 14.7838 -0.767913 33.3492 -9397 4 22.9803 28.3541 9.73828 -15.565 12.7605 -7.61321 -9398 4 22.8168 27.9481 8.31925 3.93055 -13.9923 -25.0246 -9399 6 8.64284 27.1533 24.5627 -30.3364 66.7798 9.61681 -9400 4 7.68564 27.0552 24.6389 4.16714 -15.7471 -5.05425 -9401 4 9.10482 26.3676 24.4825 22.9633 -64.4218 -6.53839 -9402 6 1.14841 23.7276 2.43845 3.37143 2.75553 -28.3576 -9403 4 1.24451 23.8913 1.47114 -2.40676 3.6179 20.3541 -9404 4 0.297784 23.2877 2.48462 -2.13531 -2.42607 6.29474 -9405 6 54.3749 30.2279 27.0351 -1.87188 5.01086 -25.6864 -9406 4 54.247 29.4439 26.4851 0.283672 1.58093 2.67322 -9407 4 54.589 30.9178 26.3677 -1.31459 -2.18642 16.2549 -9408 6 0.382292 8.43516 23.9819 16.8945 -11.9539 9.7221 -9409 4 1.32445 8.60369 24.1565 -2.20413 -11.2301 -8.89161 -9410 4 54.9553 8.73001 24.7921 -9.77823 11.7559 2.768 -9411 6 16.9131 28.5848 33.3683 -2.23593 -25.3201 -21.0962 -9412 4 17.3654 28.7863 34.1955 9.02781 -2.88055 -0.915496 -9413 4 17.3951 27.8627 32.8656 -13.2947 27.9561 26.4245 -9414 6 33.6945 30.8881 0.140848 11.5734 5.16226 7.65985 -9415 4 34.5903 30.4955 0.196618 -6.50407 7.83028 -3.90982 -9416 4 33.2725 30.4522 41.313 0.902851 -8.5209 -4.03004 -9417 6 16.2572 21.5133 34.1618 -1.32279 -12.2579 -0.0768877 -9418 4 15.8666 20.7686 33.6578 14.5936 10.7995 5.0381 -9419 4 16.7742 21.1109 34.8905 -13.5083 8.43335 -11.1581 -9420 6 0.208862 17.804 35.7536 -14.601 -29.9007 -2.72034 -9421 4 54.2286 17.807 35.5323 33.4083 9.0609 14.8615 -9422 4 0.362977 16.9429 36.1939 -0.60553 13.4006 -6.21859 -9423 6 16.8205 12.2987 0.018055 22.2965 10.2312 29.8095 -9424 4 17.2696 12.8062 0.753963 -11.4311 -8.71934 -28.0399 -9425 4 16.617 11.4478 0.422257 -11.1364 1.3302 -4.58262 -9426 6 8.24969 9.53941 36.253 -15.0171 13.8578 -6.15226 -9427 4 7.92627 8.96163 36.9484 -10.0154 -4.61382 -0.313479 -9428 4 7.46687 9.9886 35.83 14.4541 -3.15884 14.1629 -9429 6 48.5699 26.7153 39.8372 -6.05787 -6.72914 15.0837 -9430 4 48.3449 26.8926 38.9385 -16.4424 3.29077 -18.6566 -9431 4 49.4571 27.0352 39.8842 23.4859 3.73228 5.76721 -9432 6 35.4844 1.07048 23.1169 11.4549 30.8088 37.1655 -9433 4 36.0158 1.76714 22.6808 -9.17201 -14.7916 0.90361 -9434 4 35.6328 1.27141 24.1103 0.373025 -19.0496 -44.6811 -9435 6 20.2784 30.6315 19.3752 23.9103 -21.6662 15.3888 -9436 4 20.3116 31.0532 20.259 -5.42732 -3.95571 -8.57186 -9437 4 20.9344 29.8759 19.4191 -22.0709 25.9102 -5.54449 -9438 6 44.3706 15.9499 1.58551 5.68582 14.4456 12.9619 -9439 4 44.3685 15.5676 2.49167 2.87795 14.7015 -16.764 -9440 4 44.6274 16.9163 1.6094 -6.5628 -31.3198 6.45039 -9441 6 53.8881 34.4681 10.5864 -33.0496 11.7448 -26.9592 -9442 4 54.422 34.2751 11.3149 32.4161 -9.35278 40.7994 -9443 4 54.2788 35.2396 10.1584 -0.0979649 -6.0993 2.73708 -9444 6 46.1388 32.8516 33.5211 5.22207 -15.0187 3.22626 -9445 4 45.9452 33.6327 33.0044 -1.75723 11.2428 -3.91525 -9446 4 47.0422 32.5752 33.2841 -5.1447 4.42718 0.252344 -9447 6 42.1248 21.9061 24.225 29.3467 -8.59285 14.1471 -9448 4 43.0897 21.6191 24.2618 -39.2895 4.06832 7.69751 -9449 4 41.7308 21.6944 25.1042 13.707 1.91177 -18.5137 -9450 6 8.13464 3.90485 11.6471 19.3767 -1.70453 -18.8264 -9451 4 7.33962 4.19894 12.0861 -8.05938 -6.79837 10.6821 -9452 4 8.35918 3.01511 11.9412 -4.68297 1.80025 9.46807 -9453 6 19.6422 41.6776 9.83213 -10.6455 12.1827 13.5714 -9454 4 18.8651 41.1405 9.66265 4.99962 -3.76564 -7.41899 -9455 4 19.3487 0.264237 10.6212 9.02518 -11.5641 -14.6522 -9456 6 42.3073 8.42404 31.6799 28.9247 6.2763 -10.2166 -9457 4 41.4386 8.38933 32.0551 -18.7028 2.48038 0.978172 -9458 4 42.5266 9.37939 31.5704 -3.99861 -19.3235 1.7837 -9459 6 26.9144 16.155 25.3557 3.37886 4.46922 -29.1574 -9460 4 26.8932 15.8089 24.4276 -4.09623 14.1183 21.5023 -9461 4 26.5944 15.4425 25.8888 -2.2842 -17.5105 15.3426 -9462 6 48.2339 6.48607 12.6213 -2.32796 -4.32122 -9.13051 -9463 4 48.9884 6.29985 12.0375 -6.36801 1.93824 2.64233 -9464 4 47.4521 6.15437 12.1363 8.14441 0.739204 7.03502 -9465 6 53.4551 41.5313 30.6545 -6.55363 -20.9747 -16.7061 -9466 4 53.9707 41.8328 29.895 1.38615 3.54438 2.31965 -9467 4 53.5938 0.199493 31.3858 11.9182 14.0856 15.8016 -9468 6 47.0766 22.4304 31.8083 3.49024 11.2606 -9.33253 -9469 4 47.8957 22.458 31.249 -27.0486 7.80914 13.6686 -9470 4 46.5597 23.2507 31.6033 14.3992 -20.3875 6.89099 -9471 6 19.5103 5.43818 15.252 80.4346 7.77941 -36.259 -9472 4 19.9845 4.58151 15.2093 -6.94904 10.3389 3.32724 -9473 4 18.6939 5.26573 15.6196 -64.0069 -9.45641 27.6942 -9474 6 14.6723 30.2358 33.3977 29.3194 14.0021 -15.573 -9475 4 15.2147 30.9127 32.9173 -16.9191 -15.4944 5.99358 -9476 4 15.2716 29.4658 33.3729 -9.39086 7.05787 2.01807 -9477 6 28.44 24.2314 10.4028 3.15123 -12.4056 -9.54268 -9478 4 29.226 24.4262 10.8786 32.4584 2.85658 2.79411 -9479 4 27.8296 24.5485 11.0342 -36.3144 6.15546 12.0187 -9480 6 5.27118 14.4387 24.4945 35.1445 25.2092 -0.0633509 -9481 4 4.43594 14.1516 24.7736 -48.8682 -19.2375 4.52664 -9482 4 5.4685 14.0235 23.6561 -3.04719 -11.4521 -9.99341 -9483 6 26.3524 19.2908 19.1818 20.1263 -20.0506 -24.4735 -9484 4 26.6388 20.1349 19.5116 -1.98461 18.5008 5.62334 -9485 4 27.0961 18.9592 18.5977 -26.1102 9.18548 27.2368 -9486 6 28.5758 7.44193 13.1857 16.8206 36.5977 2.40675 -9487 4 28.4276 6.5743 12.8854 -8.83608 -34.241 -6.14436 -9488 4 29.1296 7.84613 12.4994 -7.23682 2.38597 3.89632 -9489 6 5.36882 27.1473 37.046 11.8823 -4.88323 19.1587 -9490 4 6.08575 26.9595 37.7076 -19.1456 -1.45009 -21.6041 -9491 4 5.36685 28.0942 36.8598 5.86896 -0.355799 -4.60773 -9492 6 53.1378 13.4025 16.0996 34.2435 -3.86055 5.06914 -9493 4 54.0829 13.0966 15.9504 -32.0077 5.91706 2.7318 -9494 4 52.5847 12.6783 16.4422 5.4814 -0.344951 -11.4066 -9495 6 45.452 1.01889 24.6154 3.31322 11.7394 9.54943 -9496 4 44.8157 0.989703 23.8982 -3.33354 -4.25493 -1.52857 -9497 4 44.9019 0.844105 25.4008 9.82267 -2.51687 -6.81685 -9498 6 50.1641 2.37547 13.9256 -5.79196 7.9049 4.59273 -9499 4 50.7992 2.78767 13.3238 -3.84891 -0.754592 0.637936 -9500 4 49.4746 3.0334 14.0873 2.34893 4.7321 -2.13859 -9501 6 19.5803 31.0161 39.1628 -18.0613 -25.9328 -11.5794 -9502 4 19.7424 30.2951 38.4816 -0.347779 24.7736 22.083 -9503 4 18.6224 30.9377 39.4182 28.2801 4.19594 -11.375 -9504 6 19.2561 14.7051 10.8744 35.9018 -50.5273 5.13524 -9505 4 20.0412 14.097 10.5737 -45.0165 49.548 5.48727 -9506 4 18.7602 14.0269 11.3662 -4.16951 16.5755 -2.6658 -9507 6 4.45594 39.5485 20.1375 -7.26247 21.8372 28.3356 -9508 4 3.95576 40.4005 20.2782 15.6699 -22.2203 -5.74536 -9509 4 4.87483 39.3065 21.0019 -15.4768 4.14169 -24.4646 -9510 6 29.0152 13.3442 23.91 8.01267 35.4951 15.4816 -9511 4 28.7225 12.4574 23.7464 -4.82052 -12.6612 5.31893 -9512 4 28.8407 13.5397 24.8723 9.679 -4.85246 -32.6651 -9513 6 17.068 2.76349 17.6602 17.5731 -10.7754 -19.6116 -9514 4 16.9152 3.43747 16.9733 0.569879 -2.90947 3.06519 -9515 4 17.8166 2.20316 17.3149 -21.6663 12.1671 7.12297 -9516 6 43.4725 18.0406 17.7144 -1.44781 -24.3706 15.3127 -9517 4 43.4291 17.0524 17.7495 6.1749 24.1268 -14.107 -9518 4 43.576 18.2305 18.6573 0.474252 7.4982 -2.94392 -9519 6 25.7765 40.7491 1.25834 -5.13784 -8.67992 -41.8469 -9520 4 26.3241 41.1434 1.92597 2.9618 17.1891 5.50682 -9521 4 25.7331 41.3641 0.469204 -4.81559 -13.5206 29.0343 -9522 6 0.465549 22.8917 6.22214 -2.55797 -7.94984 -3.9446 -9523 4 0.971697 22.1453 5.8424 -8.20264 3.34524 4.91565 -9524 4 1.09943 23.372 6.75946 4.60597 5.6548 -4.31438 -9525 6 26.241 35.011 18.6432 -1.36099 17.7753 -9.20742 -9526 4 25.9471 35.9461 18.6768 6.76043 -15.7179 -8.96745 -9527 4 25.6107 34.5957 19.2286 4.79325 -10.2415 3.05652 -9528 6 16.134 31.8742 7.55305 63.3701 -24.5537 -22.1036 -9529 4 16.96 31.3344 7.22221 -43.8871 18.402 28.1533 -9530 4 16.2567 32.6659 7.02685 -6.92396 6.43503 -6.66113 -9531 6 22.9365 16.8424 28.5556 -11.8911 28.7995 -6.03551 -9532 4 23.1131 16.1224 27.957 -2.92592 -13.6094 -7.1053 -9533 4 22.1672 17.3806 28.2048 22.5292 -24.3034 15.5849 -9534 6 48.8154 29.3426 32.1508 17.6607 -5.63259 25.101 -9535 4 47.9338 29.1776 31.8283 -15.752 -0.354552 -3.67809 -9536 4 48.876 28.9209 33.0523 -3.3832 13.4569 -22.7771 -9537 6 13.1275 24.861 5.55911 -24.9858 12.0714 -24.023 -9538 4 12.9095 24.1076 4.98414 3.68764 2.77663 3.09454 -9539 4 12.4428 25.5491 5.3163 19.4298 -17.0083 16.84 -9540 6 10.97 20.7168 15.838 25.2219 -21.2413 -18.4662 -9541 4 10.9273 20.4774 14.8836 -9.78471 10.8905 20.232 -9542 4 11.8407 20.3068 16.0784 -25.4832 11.5027 -0.03881 -9543 6 13.8668 18.3675 6.9377 -17.1805 34.1284 -15.5183 -9544 4 13.9861 19.3268 7.07801 0.95534 -8.68107 -9.41428 -9545 4 14.2312 17.9937 7.71618 14.696 -22.4056 21.3209 -9546 6 13.8328 12.9436 30.6366 23.8936 8.4875 1.93436 -9547 4 14.0561 12.5213 29.7889 -15.7862 -10.4805 9.2002 -9548 4 13.0857 12.5134 31.0734 -5.46762 -5.09599 -12.1481 -9549 6 17.1276 6.33232 31.2677 66.6528 76.8842 26.6004 -9550 4 16.7194 7.19542 31.0916 2.25558 -4.54354 -1.53399 -9551 4 16.4872 5.75051 31.0533 -74.7845 -70.3194 -26.0669 -9552 6 7.63688 23.4278 20.549 2.87884 3.81634 -6.68902 -9553 4 7.34623 23.1229 19.6666 2.94756 -0.449201 10.6329 -9554 4 8.04096 24.3016 20.3852 -3.87648 -11.4978 -1.95405 -9555 6 15.5875 36.6622 25.6317 44.8659 35.0544 -6.16252 -9556 4 16.5723 36.6215 25.7443 -25.3852 -14.6967 7.558 -9557 4 15.5456 37.5452 25.2115 -8.92727 -11.7797 -1.50769 -9558 6 0.738994 10.4213 22.1809 -27.1543 -36.2471 -13.1925 -9559 4 0.031346 10.3136 21.4752 22.4259 7.4169 21.1377 -9560 4 0.614162 9.62536 22.7539 0.837437 23.266 -16.3015 -9561 6 33.4753 17.3986 33.5966 50.0322 34.9653 -25.691 -9562 4 33.729 18.3684 33.3861 -23.79 -42.9591 12.1009 -9563 4 34.1104 16.8695 33.0603 -9.99519 5.32569 13.787 -9564 6 21.6594 19.0069 20.7632 22.9673 -17.6764 -6.78691 -9565 4 22.3468 19.6741 20.9606 -3.94962 -13.1079 -1.95693 -9566 4 22.1476 18.14 20.6003 -16.6978 33.0759 6.74927 -9567 6 41.7633 20.003 16.8748 -11.326 -1.31128 -8.84591 -9568 4 42.2034 19.1563 16.9874 6.48398 -7.2756 0.328325 -9569 4 41.4682 20.0367 15.9399 8.87316 5.12137 10.7952 -9570 6 12.0358 14.9766 17.6999 -26.21 -7.2152 -26.0517 -9571 4 11.2991 14.5498 17.1995 11.2858 13.8526 14.1879 -9572 4 12.4764 14.2447 18.105 9.10187 -13.3837 13.9354 -9573 6 23.0147 11.4211 40.7142 -19.9953 11.3897 74.5259 -9574 4 22.9359 12.2968 41.1901 4.60696 -23.5555 -21.1396 -9575 4 23.3157 11.5565 39.857 19.7433 14.0142 -51.5111 -9576 6 21.0056 28.3023 24.5803 -69.1041 85.2373 -40.9106 -9577 4 20.265 28.1264 25.1705 5.37048 -3.26467 3.49678 -9578 4 21.6928 27.7549 24.7451 59.1792 -66.0576 27.8401 -9579 6 19.39 13.7159 31.9239 29.4118 -13.0288 15.1298 -9580 4 18.7661 13.9847 31.2678 -13.3276 3.02657 -9.68553 -9581 4 18.8827 13.5849 32.728 -3.24577 4.6437 7.00982 -9582 6 21.5915 2.84466 24.7134 0.208747 24.5944 -29.04 -9583 4 21.6872 3.18692 23.7998 -4.92058 -5.74628 13.5023 -9584 4 22.4885 2.58061 24.905 3.18231 -12.543 15.1704 -9585 6 11.3458 29.9955 18.8336 12.03 22.8495 18.6886 -9586 4 10.5716 30.5896 18.8018 6.29595 -15.7791 -4.99952 -9587 4 11.9743 30.476 19.4324 -17.0963 -23.9187 -22.0967 -9588 6 14.6495 22.3648 8.3568 42.8177 1.00499 7.23029 -9589 4 14.0031 23.0587 8.53935 2.83958 6.20927 5.13977 -9590 4 15.5993 22.7606 8.33857 -60.0645 -13.0658 0.526795 -9591 6 43.9468 23.6541 17.2812 -2.43742 26.8438 -12.7514 -9592 4 44.7651 23.2701 16.9945 19.1668 -3.91001 -9.18188 -9593 4 43.5028 22.9 17.6346 -11.2125 -8.13016 15.2757 -9594 6 28.0047 25.4978 27.5091 9.49546 -35.4414 -7.32855 -9595 4 27.536 26.3032 27.53 -22.6173 33.7003 2.08289 -9596 4 28.9082 25.7508 27.3241 10.2254 5.98924 0.98151 -9597 6 19.1021 26.8113 33.1456 6.96794 1.44941 -44.6281 -9598 4 19.0009 26.3889 32.2316 6.61058 22.4795 36.193 -9599 4 19.4537 27.7357 32.9996 -8.5054 -25.835 6.12407 -9600 6 6.37601 19.3499 5.67113 -3.07724 -15.511 8.20386 -9601 4 6.68786 20.0294 5.07731 7.18653 8.65774 -7.7972 -9602 4 5.56195 19.7092 6.03854 -2.87224 2.62267 4.46635 -9603 6 37.49 28.403 9.68405 -10.2736 -31.6176 -26.4717 -9604 4 37.8518 27.9475 10.4351 5.1765 10.0485 19.5132 -9605 4 37.3493 27.6251 9.09625 -2.69325 25.3221 7.01666 -9606 6 17.6998 27.0953 11.7898 -36.7906 -34.4972 13.5582 -9607 4 17.0141 26.488 11.3694 25.6316 27.0728 3.78529 -9608 4 17.4298 27.07 12.7376 6.94557 14.4563 -18.9236 -9609 6 12.8888 1.93962 24.1529 -50.3802 38.9184 -15.728 -9610 4 12.0235 2.45928 24.1313 32.0413 -19.6529 -17.3906 -9611 4 12.9222 1.7892 25.0724 13.055 -19.4335 33.1456 -9612 6 27.8476 37.1183 33.3015 17.2618 -5.56645 -20.6455 -9613 4 27.8725 37.7306 32.5366 -3.66202 -8.07766 15.1749 -9614 4 28.4268 36.3488 33.0405 -13.8477 22.6944 8.61763 -9615 6 18.6736 12.3707 6.31908 6.91225 -31.4632 27.4828 -9616 4 18.6995 11.385 6.25383 -9.67628 20.7874 -2.26223 -9617 4 18.5836 12.6888 5.4344 -4.12511 6.2973 -26.1687 -9618 6 10.1784 29.305 24.7735 -9.10204 -23.9111 21.4033 -9619 4 10.6991 28.9855 25.5395 2.35147 16.2142 -6.30056 -9620 4 9.48939 28.598 24.7147 15.6456 22.7499 -9.47694 -9621 6 7.25796 3.28933 16.2737 -3.06701 21.6066 -7.53298 -9622 4 7.8017 4.02386 16.6541 -5.18893 -18.6288 5.77884 -9623 4 6.83195 2.7267 16.9458 19.6595 6.39335 -0.783342 -9624 6 32.1965 37.5589 1.11244 17.7564 -13.393 -49.4834 -9625 4 31.8113 36.9118 1.6863 -14.8068 -2.94474 23.9511 -9626 4 32.3136 38.4192 1.49585 -8.3749 16.0852 25.1081 -9627 6 10.4319 10.1504 6.4166 -7.63199 8.14139 10.6713 -9628 4 9.50403 10.3698 6.52583 -9.38347 6.87647 -8.77798 -9629 4 10.8186 10.5343 7.22249 5.92406 -9.68277 -8.25616 -9630 6 16.1813 23.2506 37.3799 25.1097 11.6639 -4.85114 -9631 4 16.5396 23.4181 38.2693 -7.5274 5.30939 -3.10176 -9632 4 16.7237 23.8262 36.781 -18.6662 -9.83464 11.0165 -9633 6 24.0859 14.3313 36.5421 -9.86516 7.30801 -0.382215 -9634 4 25.0278 14.1902 36.5644 12.4097 -8.07045 3.76472 -9635 4 23.7255 13.9571 37.3615 2.98939 6.5027 1.55174 -9636 6 27.4763 18.5532 28.7891 -13.5271 -4.91773 7.22809 -9637 4 27.279 18.1935 29.6763 -0.617381 3.48163 -16.8994 -9638 4 26.6639 18.4733 28.2428 3.34183 3.33207 10.806 -9639 6 51.5601 10.4909 1.56577 -57.9967 -14.5533 -18.7957 -9640 4 50.8004 9.99697 1.98849 19.2905 21.9947 -18.6033 -9641 4 52.233 10.462 2.20044 35.6887 -2.31897 35.1783 -9642 6 31.1159 39.6224 27.5035 10.1927 26.9633 6.19817 -9643 4 30.6636 39.3812 28.2975 -12.6206 -22.2416 8.82104 -9644 4 31.2642 40.5609 27.7597 6.49383 -23.2522 -24.0775 -9645 6 6.91312 35.9708 14.3252 -31.0555 -15.8542 22.3873 -9646 4 7.60399 36.2341 13.7609 26.7748 16.1612 -20.4248 -9647 4 7.14109 35.0698 14.5861 -2.88708 -0.858877 1.78829 -9648 6 45.5543 7.568 29.1737 -25.5302 -4.16762 -2.13202 -9649 4 44.8976 7.53234 28.4293 19.2773 0.699039 20.3251 -9650 4 45.0852 7.16669 29.9393 6.23602 2.26061 -10.7804 -9651 6 31.3622 20.562 31.6184 9.65463 4.63597 0.319717 -9652 4 31.8498 21.4034 31.7895 1.14978 -23.5084 -11.6884 -9653 4 31.8627 19.9392 31.0494 0.180852 16.2895 10.8054 -9654 6 43.0328 31.1512 10.3804 -22.1718 15.2565 33.5805 -9655 4 42.075 30.8844 10.4741 26.7443 4.92622 -3.29861 -9656 4 43.2631 31.5811 11.2548 -4.68507 -19.1463 -31.4268 -9657 6 50.935 25.5526 12.6381 -53.0362 -11.2381 37.5759 -9658 4 50.8444 26.3707 12.1889 6.26198 32.0523 -21.5557 -9659 4 51.7606 25.1556 12.4927 46.8244 -9.35474 -8.90879 -9660 6 29.329 2.97736 3.64421 22.5456 -43.1143 -6.52899 -9661 4 29.5843 3.84773 3.82541 15.3974 46.6652 11.4603 -9662 4 28.3975 3.01514 3.57252 -35.3193 1.84796 -10.7817 -9663 6 53.9306 32.0952 20.3602 -26.044 3.42844 6.98601 -9664 4 54.8587 32.2554 20.2589 13.6369 -3.90514 -8.57062 -9665 4 53.586 31.7345 19.5218 3.48091 2.50952 8.05406 -9666 6 41.7156 29.5544 6.48768 19.5894 27.0766 -19.1548 -9667 4 40.8143 29.536 6.19581 -21.1406 0.0261655 0.681639 -9668 4 42.121 30.2839 5.93213 -7.9284 -21.0777 21.5612 -9669 6 37.8354 24.5725 39.3073 -0.786614 -2.83003 -8.48557 -9670 4 37.3057 24.1981 38.5867 -0.305281 2.91934 11.1175 -9671 4 37.4479 24.2715 40.1417 -1.64355 1.86967 -5.36783 -9672 6 46.558 27.5785 23.289 -39.9634 -64.6481 11.0379 -9673 4 46.4646 27.3918 24.2576 6.74558 16.0433 -18.2165 -9674 4 45.9199 26.8188 22.9475 37.5572 46.869 6.09964 -9675 6 9.22773 27.2022 8.33468 -36.26 12.7871 28.7267 -9676 4 8.91275 27.6129 9.1801 5.62558 -9.89589 -23.2096 -9677 4 10.1414 27.0456 8.46037 35.2783 -3.07459 2.5747 -9678 6 36.0491 34.1608 13.9867 7.26402 -14.0442 8.68546 -9679 4 35.9913 33.1738 14.0461 -7.39622 22.1346 -4.41017 -9680 4 36.7548 34.3393 13.3524 -0.0889916 -4.95725 -2.25698 -9681 6 51.6742 14.4867 12.321 25.1613 25.5512 -24.4042 -9682 4 52.0989 14.4284 11.4335 -6.19684 -3.38259 22.4379 -9683 4 51.9807 15.3554 12.6493 -12.3863 -19.4348 1.31199 -9684 6 15.2583 19.6409 32.4144 29.0083 -20.2623 -33.8133 -9685 4 15.2558 19.2688 31.4922 3.04968 7.12699 22.6875 -9686 4 14.3622 19.8256 32.5802 -41.1763 4.86179 8.56209 -9687 6 27.6812 24.6569 38.3606 -19.0318 -31.8029 -32.3422 -9688 4 27.9736 25.1472 39.0974 14.6808 26.4307 29.745 -9689 4 28.3717 24.6185 37.6939 9.13491 6.22605 4.36089 -9690 6 37.5205 9.26898 13.6241 11.458 -4.07639 -2.41324 -9691 4 37.986 8.73412 14.2818 -4.17908 -1.66932 4.91722 -9692 4 37.422 10.1332 14.0472 -5.80925 -1.58022 -1.38856 -9693 6 20.8962 33.2419 26.2614 5.37543 12.855 -2.41316 -9694 4 21.3204 33.4412 27.1125 -5.30181 -3.15861 -4.46659 -9695 4 20.9369 32.3076 26.1263 8.87353 -20.0108 1.20924 -9696 6 6.59104 13.9455 35.2329 -26.8274 -4.60486 4.58094 -9697 4 6.38745 12.9897 35.2457 11.7642 5.99643 -3.17645 -9698 4 7.53507 14.0926 35.2395 12.5421 -8.77428 2.26249 -9699 6 10.0726 7.48467 6.8792 2.12641 6.95589 -11.9404 -9700 4 9.21804 7.15917 6.5645 -4.80657 -1.75614 5.47812 -9701 4 10.1222 8.42177 6.5916 5.16955 -15.159 7.51812 -9702 6 31.1977 5.95154 11.4339 24.7603 28.3677 15.6689 -9703 4 31.4296 6.16733 12.4018 -4.97657 -8.97631 -41.3224 -9704 4 31.9131 6.32779 10.8565 -11.9651 -11.6794 24.5691 -9705 6 12.1328 3.85103 35.2933 -10.0815 -12.0493 27.5499 -9706 4 12.7851 4.21657 34.7189 20.4312 8.87509 -12.0205 -9707 4 12.5123 3.89786 36.1903 -2.36263 6.36147 -16.6701 -9708 6 5.35168 6.07805 27.6549 3.96089 -18.0524 46.6648 -9709 4 5.01336 6.85569 28.0965 2.16186 8.49085 15.9688 -9710 4 5.1377 6.25223 26.7855 -7.5711 11.2001 -66.4514 -9711 6 13.1382 33.574 1.68419 20.6109 34.6607 2.95503 -9712 4 12.5953 33.0967 1.0817 -13.6453 -8.09858 -18.4215 -9713 4 13.3822 34.4502 1.26439 -11.0211 -27.5174 16.1165 -9714 6 44.6427 10.3996 29.0359 8.91116 23.4714 -13.18 -9715 4 44.4953 9.45294 29.0952 0.434286 -4.87704 -7.20081 -9716 4 44.1618 10.7755 28.2587 -0.00111917 -13.6507 16.636 -9717 6 9.15295 24.5944 6.37753 4.35763 15.0755 22.3214 -9718 4 8.87327 24.2546 5.53613 0.42871 5.14079 -20.2862 -9719 4 9.64462 25.4438 6.24707 -3.48643 -17.4971 -5.55606 -9720 6 52.5676 27.2719 21.6547 -2.39965 -30.061 -11.5856 -9721 4 52.5233 26.307 21.7841 0.332471 11.3908 13.792 -9722 4 52.7558 27.2791 20.7178 5.02488 16.4903 -8.77251 -9723 6 7.3066 16.9604 33.5537 -1.04195 2.49046 -7.43677 -9724 4 7.33543 17.7138 32.943 1.81348 -0.803559 0.920864 -9725 4 6.38938 16.6816 33.595 -7.62852 -0.129201 -7.36731 -9726 6 43.922 25.2186 7.97522 -0.776236 -10.551 19.3716 -9727 4 43.2647 24.8119 8.58447 10.2741 2.86697 -16.6436 -9728 4 43.4353 25.9147 7.53069 -5.46224 6.25576 -5.43654 -9729 6 2.0869 27.1165 13.6049 -6.62274 17.6596 -9.16822 -9730 4 2.19606 26.2295 13.9488 0.235583 -10.4047 3.43352 -9731 4 2.56841 27.1544 12.7597 2.10867 -4.70259 8.20201 -9732 6 37.3318 18.2771 2.1863 -11.4974 3.81579 3.71073 -9733 4 37.5653 17.6745 1.47223 -1.7687 -9.97531 1.83125 -9734 4 36.746 18.9091 1.7765 -5.93566 5.03593 -3.95155 -9735 6 24.9999 10.057 0.434977 -12.0635 -2.74649 0.799886 -9736 4 24.3308 10.4048 41.7106 3.78591 -9.33137 12.164 -9737 4 24.5954 9.37599 1.02184 5.69483 17.6459 -16.041 -ITEM: TIMESTEP -10 -ITEM: NUMBER OF ATOMS -9737 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 5.4990000000000002e+01 -0.0000000000000000e+00 4.1909999999999997e+01 -0.0000000000000000e+00 4.1909999999999997e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 9.97007 5.59928 0.0158605 6.82717 25.1566 0.173859 -2 2 9.62356 5.56404 40.5109 2.42388 15.8202 -17.9785 -3 2 8.17494 6.05177 40.4142 55.7411 37.9916 -4.02595 -4 3 7.24177 5.30408 40.552 -31.6102 -16.3698 1.50252 -5 4 9.18703 5.26911 0.576869 6.09491 -0.0281501 2.37507 -6 4 10.258 6.55078 0.333037 -13.6694 -25.1619 -9.93433 -7 4 10.7495 5.00053 0.227298 4.73684 -5.2578 1.97242 -8 4 10.3453 6.24708 39.9044 -16.4644 -11.4072 20.4818 -9 2 9.76873 4.13927 39.9675 -11.4588 -40.6165 34.779 -10 2 9.50273 3.78744 38.4932 15.666 28.6261 8.68394 -11 5 10.1133 2.12508 38.0108 0.295651 13.5297 3.11239 -12 2 9.21855 1.10832 39.2168 14.7368 7.58368 -1.20954 -13 4 9.08721 3.4839 40.6484 10.5431 15.7462 -21.5186 -14 4 10.7894 3.80905 40.2705 3.27862 -1.66199 -9.78219 -15 4 9.96352 4.6291 37.9056 6.4614 -19.967 -0.497951 -16 4 8.45197 3.92389 38.2658 -20.9649 -8.28542 -1.62155 -17 4 9.45855 1.42591 40.2577 0.123087 -4.74543 -3.47868 -18 4 9.48787 0.0601841 39.0477 5.23249 -11.9374 1.58081 -19 4 8.1518 1.18086 39.043 -21.148 5.31153 -2.14239 -20 1 8.09229 7.41048 40.3029 -14.2332 10.7223 -5.89196 -21 2 6.79937 8.10304 40.1889 5.24089 -19.8495 27.4218 -22 2 6.18195 7.49232 38.9365 0.114954 6.75236 -38.7125 -23 3 6.7427 7.67352 37.8124 -12.8129 -5.94191 21.2876 -24 4 8.91546 8.03754 40.1502 -4.33809 -15.705 2.93584 -25 4 6.18636 7.83053 41.1247 8.71228 4.86543 -21.2479 -26 2 7.05427 9.64124 40.1755 -39.1485 4.05492 14.7867 -27 2 5.78354 10.5475 40.1236 1.30256 17.7056 10.1762 -28 2 4.88546 10.5193 38.8862 -3.79578 -25.0164 33.8013 -29 3 5.09523 11.2746 37.9701 4.75276 20.2207 -26.2166 -30 1 3.8145 9.69296 38.9578 -10.6259 3.8922 -22.0733 -31 4 7.59986 9.93872 39.279 22.1314 0.316188 -7.87442 -32 4 7.59095 9.90263 41.1476 2.09094 2.02455 -19.3111 -33 4 6.10317 11.6308 40.2015 3.5236 -15.0099 -9.27626 -34 4 5.16114 10.4864 41.0336 -3.30627 -13.4665 3.57605 -35 4 3.54863 9.07856 39.7488 8.69916 3.95403 -0.745788 -36 4 3.18874 9.68238 38.1158 12.5738 1.24403 17.0425 -37 1 5.02604 6.79083 39.0278 7.4524 -0.797845 -45.9123 -38 2 4.17847 6.29332 37.9221 -3.7942 -15.2224 -3.95324 -39 2 2.69747 6.67222 38.2029 32.4064 16.6491 21.8024 -40 3 2.47317 7.27763 39.2627 -13.9875 -5.03172 -5.20453 -41 4 4.49693 6.75941 39.8611 -16.5463 3.77927 46.4214 -42 4 4.45927 6.7815 36.9606 1.68834 7.22657 1.16434 -43 2 4.32357 4.73766 37.6872 -14.444 16.6417 -7.09057 -44 2 3.62009 3.87951 38.7772 14.6644 -34.8859 1.43809 -45 2 5.79989 4.34797 37.5209 14.6689 -37.6664 -23.8861 -46 2 3.73665 2.34984 38.4383 -15.0607 27.3941 -9.62179 -47 4 3.8042 4.58537 36.6865 5.44811 -8.07725 9.84866 -48 4 2.54132 4.09064 38.8487 -7.82462 7.38089 1.0406 -49 4 4.05844 4.00808 39.8052 -1.99007 7.91776 -7.51683 -50 4 6.34139 4.39198 38.494 2.7915 9.59572 -3.8015 -51 4 6.26587 4.94741 36.6895 -0.816692 -0.0793993 15.4171 -52 4 5.96503 3.2496 37.1567 -11.5696 29.092 9.48874 -53 4 3.39623 2.18998 37.357 4.41378 -5.40883 18.8177 -54 4 3.12239 1.76276 39.1489 -5.35757 -4.6989 -2.16583 -55 4 4.76682 2.00075 38.5743 10.6291 -5.64517 -2.52342 -56 1 1.71265 6.3536 37.3575 -33.5913 -12.5481 -9.77554 -57 2 0.284755 6.62158 37.6816 12.6554 33.7668 -4.20076 -58 2 54.3822 5.43344 37.3699 -27.7691 3.87457 8.29319 -59 3 54.7838 4.49252 36.6867 3.01204 -3.04336 -3.37779 -60 4 1.82497 5.72672 36.5372 4.10411 3.68048 5.38879 -61 4 0.194803 6.88576 38.7694 2.48378 -12.979 2.09758 -62 2 54.7189 7.90551 36.9466 -7.72609 -12.13 5.61678 -63 2 0.656639 9.069 36.6919 -2.01357 8.03554 13.9604 -64 2 1.52683 9.2194 35.5966 7.55435 5.75852 -14.6577 -65 2 0.515029 10.1503 37.577 28.0972 23.5099 -14.6501 -66 2 2.25128 10.4257 35.3726 -4.96866 -39.5758 -10.6477 -67 2 1.27413 11.3326 37.3973 2.53894 16.486 1.64204 -68 2 2.1477 11.4375 36.2812 10.2448 65.1187 39.3263 -69 4 53.8018 8.25583 37.5371 13.1335 -2.90056 -11.9634 -70 4 54.3208 7.62968 35.9579 -2.73912 -6.0948 -8.85904 -71 4 1.62786 8.40831 34.848 -1.08621 1.70246 3.68663 -72 4 54.8519 10.113 38.4282 -15.3846 -1.92761 17.9785 -73 4 2.932 10.5406 34.5118 -0.192368 -3.19302 0.526177 -74 4 1.1987 12.2443 38.1226 0.692592 -32.2473 -20.0357 -75 4 2.79857 12.4271 36.2097 -23.9561 -41.0367 -3.09354 -76 1 53.0712 5.5328 37.7893 -5.57771 32.7805 23.2413 -77 2 51.973 4.62909 37.5111 5.69369 -27.8287 -42.174 -78 2 50.7933 5.44178 36.9635 6.83138 2.9595 14.8019 -79 3 50.2601 6.28483 37.7029 -2.00888 -3.43203 -15.9694 -80 4 52.7232 6.34215 38.4237 19.8206 -30.3225 -23.0649 -81 4 52.294 3.8899 36.6472 -5.7065 17.91 27.0613 -82 2 51.558 3.79481 38.7755 -4.51595 7.33433 1.21121 -83 2 50.3828 2.83682 38.5018 -9.13901 -44.4412 -29.5986 -84 2 52.8166 3.00155 39.2294 -15.7012 -7.04664 11.9409 -85 4 51.1774 4.47766 39.5861 12.1653 -0.853429 -2.8896 -86 4 50.5215 2.15128 37.5875 8.57056 17.9281 16.1392 -87 4 49.4053 3.30815 38.2892 0.50336 12.9055 3.57196 -88 4 50.1645 2.10956 39.3273 7.20165 10.7054 2.61524 -89 4 53.3305 3.56036 40.0335 2.85201 1.25263 3.90533 -90 4 53.556 2.88446 38.4204 4.77396 -6.45058 -3.13498 -91 4 52.5519 1.98529 39.6413 5.25091 8.27159 -2.68354 -92 1 50.4114 5.20625 35.6841 -20.1476 8.87025 -3.50293 -93 2 49.1688 5.73971 35.0966 -28.9774 8.99335 -1.66554 -94 2 48.0726 4.67952 35.3573 13.5632 -27.7837 -20.7653 -95 3 48.2724 3.51151 34.9309 -12.9152 20.0019 12.3092 -96 4 50.758 4.377 35.1895 1.67728 -2.63512 -1.50997 -97 4 48.8371 6.69602 35.5973 10.748 -7.18216 5.66994 -98 2 49.2038 6.04752 33.5367 10.0422 21.5226 29.5984 -99 2 47.9776 6.84135 32.9981 5.60977 17.6728 -19.5296 -100 2 48.06 7.31101 31.4919 41.3779 8.51018 8.58065 -101 2 48.2223 6.22581 30.3803 10.2277 10.7815 -8.37061 -102 1 48.1882 6.76889 29.0124 -44.0668 -20.3552 -6.98541 -103 4 49.2392 5.11894 32.9842 10.5057 -23.1259 -12.3022 -104 4 50.1653 6.62923 33.3927 -11.345 -5.02104 -10.4632 -105 4 47.825 7.77207 33.6051 2.48464 -5.23088 2.05035 -106 4 47.0343 6.2773 33.0942 -1.95432 -7.79908 6.21428 -107 4 48.9189 8.07819 31.4105 -13.7973 -19.6161 -0.159439 -108 4 47.1832 7.92091 31.2683 -17.7289 5.61577 -2.96622 -109 4 47.3306 5.536 30.4593 16.0468 -5.76301 1.4082 -110 4 49.2642 5.74618 30.4425 -24.8663 -4.45667 9.08666 -111 4 48.9827 7.28362 28.7526 29.3958 17.558 -6.10605 -112 4 47.3901 7.43056 28.8463 17.4375 -26.0151 1.0329 -113 4 48.1308 5.99149 28.2967 -4.23626 26.2635 18.8845 -114 1 46.923 5.03715 35.9679 -17.5656 23.7329 15.0201 -115 2 45.6707 4.26397 36.0383 7.41887 0.1342 36.2715 -116 2 44.9083 4.3955 34.7419 -9.99807 18.7078 -56.0122 -117 3 45.3082 5.1515 33.8118 -11.5681 -21.3087 27.1246 -118 4 46.8218 5.98238 36.4144 8.23522 -16.4135 -11.8728 -119 4 45.8989 3.17264 36.1884 2.80321 2.94058 -5.13324 -120 2 44.7401 4.70263 37.2808 -1.60464 -36.3649 -20.2774 -121 3 44.4616 6.07663 37.208 27.8602 32.4116 16.0792 -122 2 45.244 4.25605 38.6868 21.6281 49.2853 -20.5016 -123 4 43.7497 4.17807 37.1099 13.0537 7.54308 5.65065 -124 4 45.2592 6.57873 37.5303 -28.9412 -17.1189 -11.5145 -125 4 45.9129 5.11546 39.1089 -19.7485 -23.953 -1.10378 -126 4 45.8752 3.36487 38.6536 3.71139 -12.8851 -1.61893 -127 4 44.3595 4.03827 39.3021 -3.33201 1.23649 16.0156 -128 1 43.7613 3.66416 34.5997 13.2589 -16.0433 44.4251 -129 2 42.7828 3.62815 33.5465 18.9204 -1.21878 -42.6601 -130 2 41.7763 4.78741 33.7016 8.26701 -3.22526 52.4496 -131 3 41.2647 5.35582 32.7525 -2.05798 3.57411 -28.7638 -132 4 43.4932 3.04471 35.4154 4.99312 14.665 -20.8764 -133 4 43.36 3.79542 32.5266 -17.2288 -0.741434 30.8189 -134 2 42.0901 2.2209 33.4572 -3.06831 -30.079 -8.91003 -135 2 42.9343 0.899345 33.7586 6.86735 -2.69949 -8.81151 -136 2 42.2038 41.463 33.3849 1.50493 16.9918 14.9247 -137 2 44.2499 0.864187 32.9361 47.2855 12.5868 41.6398 -138 4 41.5678 2.05281 32.481 6.79941 12.0418 -2.16148 -139 4 41.2531 2.16469 34.1657 -6.29243 10.0771 8.19014 -140 4 43.198 0.869694 34.8519 -1.4112 0.953999 -4.44245 -141 4 42.8702 40.5903 33.6002 -4.10478 0.398246 -9.68788 -142 4 41.7896 41.4589 32.3582 7.27854 -3.68783 -7.38435 -143 4 41.3262 41.3063 34.0224 -6.75638 1.39507 6.42691 -144 4 44.0947 0.829251 31.8728 -5.75954 4.64229 -28.5029 -145 4 44.9396 41.8855 33.1737 -20.9549 12.1515 -1.19165 -146 4 44.9309 1.76601 33.2059 -22.5069 -20.3291 -10.4095 -147 1 41.5145 5.2236 34.9901 10.2672 4.08625 -51.0356 -148 2 40.6676 6.35891 35.268 -24.1778 -10.7223 -7.79527 -149 2 41.3691 7.72376 35.0974 2.95483 13.7574 -3.11119 -150 3 40.6975 8.75349 34.8431 -2.15612 -12.5202 3.44484 -151 4 41.8176 4.64617 35.7553 2.04542 -7.36824 24.1106 -152 4 39.8621 6.3427 34.4551 10.5786 9.41727 7.44594 -153 2 39.8405 6.1283 36.5756 19.8539 -2.67173 26.8296 -154 3 40.7601 5.89106 37.6735 -0.128972 20.3018 -14.678 -155 2 38.9248 4.89402 36.5497 -24.3083 -6.19306 -11.8519 -156 4 39.228 7.01129 36.8511 -0.372961 8.24506 -6.20484 -157 4 41.1549 6.75425 37.8536 -4.13097 -9.7211 -3.01543 -158 4 38.1722 4.94482 35.71 1.05658 9.14576 13.4136 -159 4 38.3953 4.71355 37.5213 -1.28546 9.2328 -6.30902 -160 4 39.3771 3.92967 36.3433 23.1336 -11.0543 -1.24287 -161 1 42.7302 7.8059 35.1562 3.49276 1.34371 4.78693 -162 2 43.5269 8.99303 34.9539 -8.19772 -21.7996 13.9087 -163 2 44.4646 9.39471 36.0778 41.0762 49.5413 -62.5687 -164 3 45.3993 10.2183 35.7654 -29.643 -36.0587 21.7786 -165 4 43.357 7.05719 35.4614 -7.13629 -15.5308 5.06399 -166 4 44.0803 8.92821 34.0189 14.2015 -9.60403 -10.8131 -167 4 42.9032 9.83742 34.7399 -16.6431 23.0824 1.78637 -168 1 44.28 8.95267 37.3076 -5.41717 -6.01048 56.4016 -169 2 45.1954 9.30059 38.3934 14.0544 9.09198 9.45122 -170 2 46.5736 8.71838 38.034 -4.40481 25.0392 4.24124 -171 3 46.7239 7.52665 37.7592 -2.06685 -10.8071 -7.31186 -172 4 43.4369 8.46722 37.66 -0.808029 1.80219 -13.797 -173 4 45.2932 10.4319 38.4595 -5.35026 -12.3633 -15.6489 -174 2 44.7775 8.83735 39.8303 19.1756 -23.9015 -7.23155 -175 2 45.4882 9.63492 40.9425 5.24315 -15.5914 27.8506 -176 2 45.0424 11.1143 41.0465 6.36216 -11.291 -10.339 -177 2 45.9827 11.9035 0.041605 38.3537 -2.96327 34.4916 -178 1 45.5586 13.2421 0.396463 -0.785075 15.3756 28.9492 -179 4 44.9912 7.72238 39.9953 -4.79728 17.8629 -7.78445 -180 4 43.7049 8.96345 39.9422 -22.2512 0.44531 4.07292 -181 4 46.5908 9.56019 40.8161 0.364544 3.82252 -6.52459 -182 4 45.3434 9.10335 0.0599805 -5.24686 13.9981 -23.7842 -183 4 44.0132 11.1324 41.4274 -10.2695 3.39123 6.70816 -184 4 44.9981 11.6023 40.04 1.8072 0.416607 6.15726 -185 4 47.0442 11.9436 41.5493 -17.6115 6.73335 -5.13538 -186 4 46.1824 11.4052 1.05233 -16.0491 -0.928483 -18.7699 -187 4 45.666 13.9003 41.5429 -6.15709 2.25656 -0.794581 -188 4 46.187 13.6261 1.17403 -31.6799 -14.737 -27.4943 -189 4 44.5482 13.2658 0.707841 33.0262 6.71149 -7.77427 -190 1 47.5786 9.61919 37.9975 -0.262725 18.6124 2.96873 -191 2 48.9681 9.33197 37.6414 -20.2336 1.72319 -17.1083 -192 2 49.7588 9.70622 38.88 39.5209 -76.7499 14.8721 -193 3 49.6145 10.763 39.4317 -9.44289 38.5374 13.5639 -194 4 47.4009 10.6083 38.3248 7.77058 -18.5649 -8.96176 -195 4 49.0172 8.23798 37.4216 9.46753 0.884559 0.506936 -196 2 49.3323 10.1282 36.3163 3.6714 0.82331 31.2642 -197 3 48.3563 9.85046 35.3281 -8.1318 -4.77519 -4.71381 -198 2 50.6865 9.72677 35.695 -19.0046 0.743943 -11.7808 -199 4 49.2557 11.2077 36.6021 8.67648 2.0602 -8.11811 -200 4 47.5419 10.2678 35.5977 -2.15846 0.170791 -0.678761 -201 4 50.8563 10.2671 34.7416 2.67544 8.24981 1.47477 -202 4 50.7066 8.66813 35.3754 2.1247 -7.47433 7.78713 -203 4 51.5309 9.954 36.3541 9.43429 -0.352141 7.40173 -204 1 50.5004 8.65755 39.48 -48.513 49.986 -45.0014 -205 2 51.0618 8.74392 40.7907 20.8089 -26.4742 28.5407 -206 2 52.5708 8.35776 40.7906 -32.7343 -31.0986 -30.3541 -207 3 52.9098 7.36002 40.1044 19.6712 31.5314 12.7437 -208 4 50.5882 7.8265 38.898 12.8881 -18.9119 10.2231 -209 4 50.9863 9.78895 41.141 -1.46865 8.60563 4.12328 -210 2 50.3037 7.79505 41.8358 -16.725 28.936 13.8764 -211 2 50.252 6.27959 41.4904 27.2589 15.6434 -4.64867 -212 2 48.8609 8.35011 0.225019 8.85004 14.588 -17.6069 -213 2 49.3953 5.42325 0.497373 -18.8945 7.05888 30.2377 -214 4 50.814 7.95159 0.918621 8.35305 -8.94958 -7.30269 -215 4 51.3186 5.93048 41.4774 -6.84536 -5.23847 5.64953 -216 4 49.9408 6.1608 40.4387 -8.33431 -3.05112 -5.55566 -217 4 48.166 7.96072 41.344 -1.46 7.63128 5.53427 -218 4 48.8165 9.51657 0.246026 0.467008 -30.2893 -0.065267 -219 4 48.5175 7.97406 1.21641 -4.07563 3.27994 -1.48455 -220 4 48.2983 5.58085 0.347667 5.50609 -0.627552 -5.84055 -221 4 49.5344 5.58322 1.60624 7.63779 5.91871 -13.4594 -222 4 49.5909 4.36583 0.361303 3.03099 -20.7712 -9.01704 -223 1 53.3669 9.15083 41.5136 39.5682 14.7354 5.79836 -224 2 54.8443 9.26777 41.6313 -32.7918 27.0996 3.53674 -225 2 0.372396 8.2907 0.722751 15.0567 -33.4937 20.6099 -226 3 54.8856 8.2259 1.87915 11.4238 -3.26125 -20.3466 -227 4 52.9167 9.73978 0.288924 -10.841 14.2188 11.5997 -228 4 0.25416 9.07559 40.636 9.98484 -5.7038 -17.1316 -229 2 0.351513 10.7152 0.19938 0.985642 14.1538 -10.6635 -230 3 54.4575 11.7797 41.7528 -11.3464 -18.6066 -9.73211 -231 2 1.66903 11.1049 41.4122 7.34382 -22.4378 -10.8926 -232 4 0.4803 10.8256 1.29559 2.15483 -15.9854 6.57991 -233 4 54.1789 12.1729 0.660397 -4.76608 7.18995 2.46446 -234 4 2.02372 12.0909 41.706 2.9877 17.6459 6.95349 -235 4 1.57896 11.139 40.2943 0.339955 -2.68366 6.65003 -236 4 2.50746 10.4017 41.6821 -7.50419 3.69742 -2.77337 -237 1 1.45709 7.55056 0.343709 0.783377 10.0466 -6.42735 -238 2 2.26763 6.65075 1.15078 -32.6055 -6.94536 -7.22798 -239 2 3.71498 6.9634 0.985171 49.9575 39.4499 -62.468 -240 3 4.16139 7.41516 41.7733 -24.7374 -20.1855 46.264 -241 4 1.86812 7.64334 41.3079 -3.10568 2.79536 2.39364 -242 4 2.02547 6.77359 2.21072 -7.15361 5.99983 10.1715 -243 2 1.97017 5.19949 0.677115 9.24237 23.8034 -8.70369 -244 2 0.525 4.76245 0.942436 -1.25511 -23.3688 27.6866 -245 2 0.292475 3.39123 0.300736 12.896 -21.1671 11.4366 -246 2 0.300138 4.59931 2.47443 -32.0383 1.7301 9.08136 -247 4 2.70003 4.54767 1.15632 6.2908 -16.3803 10.1517 -248 4 2.22696 5.13751 41.5068 -3.29253 -1.30987 -4.15087 -249 4 54.7656 5.47042 0.590489 -8.39992 14.3218 -15.0438 -250 4 54.2418 3.05018 0.328915 -13.2626 1.11831 3.00682 -251 4 0.884488 2.58096 0.823664 -4.50955 14.351 -5.98985 -252 4 0.593908 3.34298 41.1636 3.48003 3.40906 -16.1017 -253 4 0.952355 3.83641 2.92287 8.67303 -5.41594 2.10418 -254 4 54.195 4.2418 2.71744 29.7111 15.4634 -7.25797 -255 4 0.523461 5.5584 3.03176 -8.55492 -11.4476 -4.98522 -256 1 4.54724 6.69628 2.0028 -11.6083 -5.66543 -5.23244 -257 2 5.9708 6.78048 2.07185 29.6953 24.7002 11.5216 -258 2 6.62679 5.47067 2.57826 -56.9161 -25.5018 -48.7527 -259 3 7.55514 5.44421 3.3345 43.3901 -4.04961 27.9945 -260 4 4.11753 6.29088 2.82459 -1.31884 -6.15538 19.0144 -261 4 6.38329 6.99012 1.0501 -1.44469 -12.2628 1.79191 -262 2 6.4556 7.99651 2.97484 -29.1307 10.2847 -18.0571 -263 2 6.5028 9.34873 2.22705 -18.2939 24.7932 5.04877 -264 2 6.67525 10.5485 3.20576 -19.6949 -28.8822 -17.9407 -265 3 7.83409 10.9407 3.49149 14.4815 4.00472 5.8048 -266 3 5.6204 11.0576 3.67938 3.00737 1.04452 3.25275 -267 4 7.46376 7.72864 3.29072 15.5933 3.84479 14.8832 -268 4 5.82416 8.22265 3.87848 3.62309 -20.6245 -0.107855 -269 4 5.50278 9.55154 1.65377 27.7023 -9.35583 7.15892 -270 4 7.36204 9.37759 1.52673 -1.86837 -2.39822 -10.1271 -271 1 6.01547 4.32119 2.13096 24.825 18.8056 21.8908 -272 2 6.40109 2.94617 2.38906 -11.7575 -20.1643 -12.9237 -273 2 7.81521 2.61654 1.77783 -56.2322 2.45294 33.4207 -274 3 8.31478 3.35811 0.966233 17.239 19.087 -22.9985 -275 4 5.23593 4.40493 1.50032 -13.4301 6.78787 -12.4159 -276 4 6.42741 2.74871 3.48587 6.57798 6.02642 3.28221 -277 2 5.2086 2.00284 1.82478 32.9723 -19.5112 -16.552 -278 2 3.90497 2.10853 2.63909 4.11684 35.775 58.6384 -279 2 4.90372 2.28313 0.318971 -25.0993 -16.9694 6.10511 -280 4 5.56913 0.900136 1.85726 -4.66192 22.2662 6.6067 -281 4 4.03562 1.77943 3.74204 2.08752 -4.13501 -29.3045 -282 4 3.08076 1.58512 2.20328 -21.6762 -25.4002 -11.7361 -283 4 3.47043 3.14079 2.79739 15.5883 -5.24062 -11.8252 -284 4 4.40039 3.24668 0.146776 -5.79992 5.24774 -1.28692 -285 4 4.20501 1.47402 41.8336 8.41255 14.6516 3.66501 -286 4 5.77159 2.28177 41.569 16.6343 -1.64949 -4.80555 -287 1 8.4358 1.54559 2.27475 36.6082 -11.5601 -11.8896 -288 2 9.77403 1.09441 1.8307 -27.8835 12.6882 -14.7267 -289 2 9.60932 41.7912 0.904414 -8.95822 -4.80133 -2.77359 -290 3 8.60977 41.0717 1.04857 16.9017 -0.350054 -8.54673 -291 4 7.96937 0.851078 2.83344 -16.1443 -13.3321 15.6909 -292 4 10.1447 1.96102 1.23179 21.7718 -7.90657 2.9301 -293 2 10.6071 0.627222 3.03652 -0.441548 -3.06629 28.3632 -294 2 11.1182 1.69736 4.03374 -39.6019 -9.33118 23.345 -295 2 12.4276 2.26482 3.60541 40.3504 -3.80329 2.03759 -296 3 13.4833 1.65854 4.00477 -10.9735 16.3163 -6.96273 -297 3 12.4619 3.21875 2.76405 -4.75337 -1.04793 7.93588 -298 4 11.5429 0.117807 2.72279 -4.90068 -9.43781 -6.0473 -299 4 9.98495 41.7532 3.61242 16.0495 13.2539 -10.4034 -300 4 11.2741 1.17979 5.05068 -3.18835 9.28581 -16.8758 -301 4 10.3234 2.48031 4.23808 10.2695 -6.11036 -3.24845 -302 1 10.6563 41.4604 0.0588169 -6.20046 -15.666 -8.24155 -303 2 10.7096 40.1842 41.1911 4.64874 21.5238 9.65168 -304 2 10.6577 38.9638 0.161439 -6.67174 -46.3648 23.9629 -305 3 10.1435 37.8848 41.6696 11.1653 29.5239 15.2576 -306 4 9.85832 40.1011 40.5066 -14.3391 4.69386 -5.52668 -307 2 12.0141 40.2124 40.3653 4.26726 1.71904 -5.44169 -308 2 12.4668 41.6661 40.4777 -1.00635 15.6111 -33.0282 -309 2 11.8673 0.323303 41.767 -12.6506 -21.5702 -15.1443 -310 4 11.8545 39.873 39.2959 0.539662 6.91875 10.5587 -311 4 12.8304 39.5641 40.7546 -3.32338 -3.68521 7.20301 -312 4 12.0951 0.327352 39.5607 -0.26902 -6.73625 15.8499 -313 4 13.5766 41.7696 40.398 -3.05617 -0.547794 6.53436 -314 4 11.6542 1.3898 41.6565 2.06281 16.0871 1.21765 -315 4 12.5433 0.162045 0.691867 15.5992 2.8717 16.0141 -316 1 11.2193 39.0766 1.4086 -4.36655 24.7542 -22.059 -317 2 11.4309 38.0888 2.42328 2.01986 -2.25877 10.0578 -318 2 10.2357 37.7662 3.3374 -3.13249 5.62439 -12.9442 -319 3 10.4243 36.9709 4.25096 -6.41092 -9.96708 1.94465 -320 4 11.5904 40.0068 1.66465 -1.36758 -8.10945 4.45955 -321 4 11.6246 37.1209 1.91909 1.66244 -5.96089 -4.69733 -322 2 12.7089 38.4628 3.26447 -19.7243 1.96837 18.865 -323 3 12.593 39.7548 3.85012 -16.3579 -13.4437 -0.292868 -324 4 13.6002 38.4999 2.63657 13.9756 -7.10852 -11.694 -325 4 12.8962 37.7302 4.10036 -1.36843 4.44789 -10.4248 -326 4 11.9859 39.6657 4.60642 10.4094 13.6351 -5.41979 -327 1 9.02275 38.3618 3.12708 -24.8633 34.0603 -47.8229 -328 2 7.7797 38.1104 3.9237 -5.5143 -4.40103 -12.4219 -329 2 6.80948 37.1627 3.16843 27.134 16.5749 8.61656 -330 3 6.86683 37.0056 1.95165 6.52379 13.0808 -10.3152 -331 4 8.81363 38.9852 2.21874 13.7891 -35.0234 50.9651 -332 4 8.06628 37.5753 4.84119 7.22917 -10.5654 7.4735 -333 2 7.01568 39.4093 4.3407 2.69101 -11.9593 -14.7657 -334 2 7.81876 40.1019 5.42325 -6.79454 3.60365 -28.1432 -335 3 8.28496 41.241 5.20721 -2.75331 10.4655 -0.123769 -336 3 8.08719 39.4782 6.47272 0.652509 -5.2024 22.4807 -337 4 5.97814 39.1687 4.67547 5.82193 1.31451 7.85599 -338 4 6.83632 40.0167 3.42407 6.48365 7.00102 3.75656 -339 1 5.92582 36.4787 3.90047 -14.2639 -13.8348 21.4567 -340 2 4.95916 35.6178 3.24268 -4.4575 6.83929 8.3992 -341 2 3.83929 36.4769 2.71202 -44.4588 -49.3176 -48.5312 -342 3 3.60925 37.6169 3.05258 2.07424 26.7384 14.4764 -343 4 5.8145 36.534 4.942 7.63157 5.21975 -16.3776 -344 4 5.40617 35.1414 2.34351 4.65472 -4.22423 0.555341 -345 2 4.39718 34.509 4.16235 13.2774 -34.7614 9.16528 -346 3 3.98438 35.0519 5.39575 -10.4467 6.31908 32.28 -347 2 5.50619 33.4543 4.48033 -18.4692 -3.54598 29.0115 -348 4 3.53919 33.9402 3.74776 -4.47694 5.79242 -10.2957 -349 4 3.62452 34.3759 6.00064 11.5458 5.5573 -22.0279 -350 4 5.86065 32.9579 3.58801 8.19644 -6.15464 -22.9143 -351 4 5.08151 32.5761 5.12909 16.3877 29.7333 -11.6263 -352 4 6.39565 33.9521 4.95041 -3.85278 -8.84208 3.35803 -353 1 2.97294 35.7888 1.83357 24.6732 25.9217 25.2152 -354 2 1.71267 36.3687 1.37347 -5.03432 -5.896 10.5631 -355 2 0.744229 36.5497 2.58991 -5.24139 24.3125 -23.8477 -356 3 54.9871 37.5497 2.63122 18.6385 -17.0409 3.73872 -357 4 3.28773 34.8825 1.44268 -6.98273 2.93822 -0.272558 -358 4 1.87243 37.434 1.07109 4.86902 -3.5162 -5.74397 -359 2 1.111 35.5523 0.154125 -16.9781 -2.34719 28.1775 -360 2 1.71191 35.9998 40.7076 5.75717 0.931703 -28.4951 -361 2 54.5365 35.7134 0.116808 -8.16561 0.919103 1.38616 -362 2 3.27145 35.9095 40.6267 -43.0781 7.09941 -3.6072 -363 4 1.31237 34.4411 0.36052 2.96229 18.9121 -10.1464 -364 4 1.38444 37.0145 40.3207 4.07875 -5.77915 19.4423 -365 4 1.27316 35.3433 39.9124 8.37762 -5.40948 6.65521 -366 4 54.0772 35.0942 41.2103 3.74338 3.48587 4.89864 -367 4 54.2123 36.7722 41.8688 5.5832 -2.69651 -3.34762 -368 4 54.0157 35.4055 1.08169 10.5414 -0.491815 -14.4897 -369 4 3.61367 34.902 40.8802 7.83264 -12.2373 1.45006 -370 4 3.69229 36.6315 41.3343 12.2091 5.94613 6.19684 -371 4 3.59275 36.1798 39.604 6.95495 -3.49191 -4.00644 -372 1 0.74604 35.6172 3.54454 -3.3388 -35.9018 49.598 -373 2 0.0112331 35.6552 4.85892 21.257 7.22823 -39.6883 -374 2 0.198256 37.0471 5.48367 -2.86302 -31.8341 -17.2866 -375 3 54.1912 37.6952 5.75353 -1.48181 26.0574 3.92406 -376 4 1.16676 34.6739 3.4098 -0.571923 12.3969 -9.16993 -377 4 53.9399 35.5324 4.59955 -13.6683 1.62606 4.36563 -378 2 0.479844 34.4894 5.77304 -8.63544 -0.437888 22.4632 -379 2 54.7769 34.3327 7.14546 -8.87326 -9.27459 2.92058 -380 2 0.0146857 35.4787 8.12524 6.60033 -5.57439 2.5368 -381 3 54.0952 36.3427 8.3329 8.35004 -1.43527 5.86114 -382 3 1.11008 35.478 8.75909 4.47833 6.11486 1.03148 -383 4 1.57132 34.5563 5.98457 -0.698959 1.91632 -4.64924 -384 4 0.309529 33.5134 5.28188 2.4365 -3.54209 -11.468 -385 4 0.179249 33.4003 7.64738 0.479338 5.67065 -5.66203 -386 4 53.6776 34.105 7.04833 9.83525 6.91672 -4.06122 -387 1 1.48459 37.3964 5.63734 26.9411 18.0032 -4.38534 -388 2 2.00708 38.6625 6.18614 -17.3218 -26.0277 -29.9987 -389 2 1.56827 39.8885 5.33406 1.07082 -15.6319 68.2882 -390 3 1.08143 40.8395 5.94485 1.04665 3.34176 -10.6171 -391 4 2.21263 36.6994 5.39095 -3.57075 5.04293 0.958686 -392 4 1.48422 38.7142 7.17744 15.2971 12.5748 0.959573 -393 2 3.55969 38.5843 6.25222 7.32448 -15.8569 15.0135 -394 2 4.09689 39.7132 7.09894 -5.63198 1.92213 9.01267 -395 3 4.56636 40.7179 6.56654 0.030916 3.04529 -1.1693 -396 1 3.96361 39.556 8.43894 1.042 12.9555 16.4237 -397 4 4.05831 38.7157 5.24953 -10.2579 -5.90723 4.64011 -398 4 3.91694 37.5778 6.70114 -5.07122 23.1073 -10.2752 -399 4 3.40266 38.7698 8.86734 10.6722 14.2638 -7.23316 -400 4 4.31989 40.3411 9.06061 -10.7144 -22.9188 -14.0526 -401 1 1.60475 39.819 4.02334 -43.55 39.5967 -43.6917 -402 2 0.959151 40.8062 3.12947 9.93922 10.0651 20.657 -403 2 54.4776 41.0208 3.48285 -52.4492 -13.4217 15.5726 -404 3 53.9715 0.237442 3.65017 19.1527 -10.2385 2.60078 -405 4 2.04263 39.1125 3.49268 25.4866 -43.7222 -11.6271 -406 4 1.43469 41.7946 3.36052 -1.16639 -0.650149 -3.04645 -407 2 1.13376 40.5205 1.61049 -4.45578 -2.70165 -27.9407 -408 2 0.490261 41.6149 0.695896 4.53105 0.20202 29.6943 -409 2 2.64975 40.4484 1.23692 -3.92583 -1.39436 -18.6979 -410 4 0.60342 39.5705 1.32385 8.41785 -1.89228 7.96418 -411 4 54.3692 41.6195 0.82936 4.25856 9.6792 3.81375 -412 4 0.622371 41.4492 41.5424 7.52435 -6.48816 -19.7965 -413 4 0.973053 0.688907 0.936332 -12.1275 -4.49455 -2.44597 -414 4 2.86969 40.4983 0.122209 -12.9804 -12.5133 18.6513 -415 4 3.14027 39.5547 1.69882 2.20392 3.04031 -6.93039 -416 4 3.17994 41.3387 1.56797 8.55742 10.8937 16.8775 -417 1 53.6665 39.902 3.64569 3.02926 35.878 11.6697 -418 2 52.2466 39.9148 4.06102 19.2385 27.0707 -26.8098 -419 2 52.053 40.5369 5.44904 5.36155 -11.3244 -6.70427 -420 3 51.0493 41.2119 5.6977 3.00195 1.8183 -1.23959 -421 4 54.0359 38.9941 3.4462 12.1828 -26.316 -3.91411 -422 4 51.7731 40.6655 3.34079 -4.82064 -14.7659 11.8755 -423 2 51.582 38.5149 3.95778 -5.61462 -20.1546 -9.91009 -424 2 51.4355 37.9559 2.49174 21.0062 -12.2216 22.8132 -425 2 51.0144 36.4629 2.37849 -12.7289 -13.0945 -11.3158 -426 2 50.8009 35.9817 0.883468 22.3055 45.8074 13.5352 -427 1 50.1864 34.6873 0.684667 2.36531 28.1154 -10.556 -428 4 50.5344 38.5648 4.38466 13.3699 -2.49694 2.21203 -429 4 52.2198 37.7725 4.53757 -13.8611 9.51826 -2.20414 -430 4 52.4594 37.9738 2.01537 -10.7122 14.3169 -4.94324 -431 4 50.6781 38.6054 2.01085 7.27079 0.282464 -15.5314 -432 4 50.0599 36.3043 2.92579 -2.19776 -0.350037 2.41174 -433 4 51.7586 35.7685 2.83822 0.223715 4.6579 4.31096 -434 4 51.8274 35.9658 0.402852 -15.0801 -2.53131 0.358002 -435 4 50.2142 36.8299 0.38331 4.02889 -26.7998 -2.47013 -436 4 50.6312 33.9821 1.2741 -7.74727 -6.99272 -14.4028 -437 4 50.1255 34.5169 41.5875 17.6482 -15.4813 7.31014 -438 4 49.2229 34.7469 0.909632 -22.6621 -5.40937 19.0501 -439 1 53.014 40.2496 6.3528 -7.33511 22.7823 24.6419 -440 2 53.0995 40.7279 7.73814 -49.8191 -29.044 -3.24915 -441 2 53.1557 0.329785 7.7965 36.8238 12.814 -39.8954 -442 3 52.5287 0.997511 8.60414 -15.9304 4.02299 13.5617 -443 4 53.7341 39.5741 6.15629 12.7417 -17.108 -13.0125 -444 4 52.0658 40.401 8.2322 35.0205 13.5384 -7.46142 -445 2 54.2887 40.0362 8.44194 -31.1952 -6.28028 37.9979 -446 4 54.3393 40.3597 9.51814 11.9598 15.0179 -15.3163 -447 4 0.207826 40.1934 7.85611 17.4499 5.7482 6.56468 -448 4 54.1321 38.9464 8.61757 0.233079 -2.0185 -17.8759 -449 1 53.9798 0.938968 6.8679 -0.195991 -19.5991 -5.8991 -450 2 54.0539 2.3703 6.69095 -13.0728 33.3033 12.6105 -451 2 52.7411 3.03405 6.19669 -13.7918 -57.342 -43.9621 -452 3 52.3429 4.1409 6.51048 0.805927 21.8583 24.6591 -453 4 54.6966 0.402301 6.30051 -22.9471 7.504 14.9388 -454 4 54.1387 2.85352 7.70963 6.90446 -7.48262 -5.16091 -455 2 0.230181 2.82991 5.77971 -8.39605 37.5401 -18.7849 -456 2 1.62806 2.36187 6.13631 43.8101 -17.859 13.5365 -457 2 2.01439 2.63812 7.6434 4.44409 -15.8917 -34.667 -458 2 3.251 1.82053 8.03886 10.3698 -25.435 21.3536 -459 1 3.78609 2.13458 9.37971 -1.03569 -21.7613 -70.4054 -460 4 0.236987 4.00662 5.72725 -0.841737 -32.3075 1.88093 -461 4 55.0233 2.47547 4.72977 -1.92078 4.0191 4.58104 -462 4 2.43886 2.84427 5.52141 -13.7997 6.98566 -1.14785 -463 4 1.8001 1.26942 5.8525 -13.1218 12.7308 11.199 -464 4 1.17734 2.2629 8.25415 -4.76662 9.03037 15.6753 -465 4 2.26439 3.72233 7.77766 -11.2971 -1.006 3.39024 -466 4 4.0605 1.91272 7.29579 6.96563 5.43042 -1.59904 -467 4 3.03028 0.709673 8.06144 -4.99399 12.6268 -3.20223 -468 4 3.89697 1.2978 9.90866 2.2165 -13.9672 17.3419 -469 4 3.11983 2.70535 9.83652 -2.18207 25.7622 26.4666 -470 4 4.71792 2.51816 9.23842 -3.78155 13.4581 18.6473 -471 1 52.0021 2.30339 5.27929 12.8772 20.7449 44.6796 -472 2 50.6928 2.72834 4.84618 -13.8318 -0.832969 -24.58 -473 2 49.579 2.58092 5.91693 0.565718 25.7533 -2.22664 -474 3 48.7752 3.51298 6.10069 9.60089 -13.9081 0.0850852 -475 4 52.4111 1.47967 4.84803 3.54375 -13.752 -6.04623 -476 4 50.7183 3.81521 4.5849 2.62435 0.742467 8.46338 -477 2 50.3339 2.0499 3.47904 12.4361 -26.7668 8.24264 -478 2 51.3981 2.34325 2.36407 -25.9391 22.844 -14.5031 -479 2 48.9153 2.37958 2.98651 -2.89914 40.9383 9.35249 -480 2 51.1891 1.41918 1.15407 38.5806 -15.4927 -30.3188 -481 4 50.4158 0.92469 3.65006 -8.90797 13.02 4.48026 -482 4 52.4055 2.20648 2.74929 18.7984 -5.45377 5.09466 -483 4 51.3666 3.42411 2.00589 -1.76359 -13.5005 7.53435 -484 4 48.1353 2.36077 3.79579 2.75746 -16.6411 -10.078 -485 4 48.6799 1.76326 2.11438 -14.9792 -11.0957 -5.84075 -486 4 48.8325 3.45193 2.63807 7.50371 -11.7896 -0.401559 -487 4 52.1004 1.43799 0.414216 -21.3416 1.39174 26.2203 -488 4 50.3409 1.68288 0.503068 -10.2032 3.93981 2.99084 -489 4 51.0565 0.33979 1.46483 1.72575 11.8892 -3.22767 -490 1 49.5807 1.53255 6.75244 19.5889 -24.3514 7.76629 -491 2 48.7262 1.39688 7.92951 3.12598 20.2674 -1.73108 -492 2 48.8873 2.63773 8.86406 -22.8968 -16.6402 -5.42224 -493 3 47.8891 3.05472 9.45614 -0.472007 6.27789 -5.95623 -494 4 50.2352 0.731103 6.58688 -10.8709 15.7502 1.66713 -495 4 47.6402 1.39986 7.60999 11.2933 -0.131061 -1.07735 -496 2 49.0614 0.0990051 8.70607 -29.9824 -25.1823 -11.7347 -497 2 48.2869 41.7602 10.01 13.4599 -0.122667 29.7563 -498 2 46.7828 0.0292377 10.0132 -0.929007 -24.4408 -23.1824 -499 3 46.2118 0.52149 10.9702 -12.9016 15.2185 13.9881 -500 1 46.1401 41.3429 8.96595 27.5879 22.2376 34.4467 -501 4 50.107 0.108866 8.97457 27.7162 -1.73681 3.74735 -502 4 48.8999 41.0818 8.03917 5.36927 20.2302 10.0129 -503 4 48.7183 0.460982 10.852 -8.35522 8.57003 -12.646 -504 4 48.4869 40.755 10.454 -1.65554 -4.90235 -14.5783 -505 4 46.6392 40.8985 8.22302 16.4703 -11.2583 -22.7525 -506 4 45.1487 41.2958 8.97726 -40.9601 -1.33251 0.190018 -507 1 50.0995 3.17318 9.05078 3.95851 -0.0485648 -3.79593 -508 2 50.3325 4.25644 9.97415 17.5873 21.0859 -2.62556 -509 2 49.9752 5.63804 9.37548 -18.0954 -29.5198 29.938 -510 3 49.379 6.45094 10.0988 9.73071 -4.74536 -2.58342 -511 4 50.9107 2.76055 8.59957 11.9693 -5.38147 -4.75744 -512 4 49.6509 4.09994 10.8399 -6.9467 2.38538 1.23714 -513 2 51.7744 4.26209 10.561 -12.6039 -21.2869 -0.279481 -514 2 51.8614 5.17465 11.7883 77.4573 -1.34868 -55.222 -515 3 50.9415 5.19238 12.5756 -62.6641 4.37367 45.7089 -516 3 52.9385 5.83334 11.9521 -15.5069 -3.45829 -0.856418 -517 4 52.5513 4.49045 9.80335 -1.41111 7.91559 -3.33271 -518 4 51.9847 3.17606 10.8252 3.56611 15.7947 8.37571 -519 1 50.1134 5.83384 8.05697 5.03044 -3.38183 -24.9476 -520 2 49.6949 7.07302 7.45907 -6.39224 21.6045 -14.6025 -521 2 48.2404 7.19765 6.96855 9.41443 -40.5535 -11.5325 -522 3 47.5994 8.23003 7.09737 -2.60339 17.4007 5.13595 -523 4 50.5903 5.18529 7.39903 -4.72806 0.48988 13.3104 -524 4 49.6568 7.79446 8.28532 6.84483 14.8177 6.93296 -525 2 50.7045 7.63108 6.39006 -19.8247 -9.47824 8.02755 -526 2 50.6996 6.84785 5.08902 -10.629 2.31661 -15.1243 -527 2 51.6586 7.26626 3.9659 -11.3496 43.5825 3.95364 -528 2 53.1317 7.00105 4.2557 32.8208 18.7244 -18.8206 -529 1 53.7683 7.95578 5.14747 -10.6729 7.59108 -11.9454 -530 4 51.7028 7.64661 6.81348 16.7201 -1.45014 11.0251 -531 4 50.4708 8.68128 6.19684 -5.34256 14.1207 -5.41714 -532 4 49.6713 6.8702 4.6668 -0.861277 1.74329 -1.61352 -533 4 50.8688 5.79892 5.31654 5.28855 -19.0543 2.54637 -534 4 51.4741 8.35024 3.65396 8.42695 -12.5098 16.2485 -535 4 51.3565 6.79125 3.04708 -1.5826 -26.0582 -19.3792 -536 4 53.7673 7.0998 3.31183 -20.6632 -9.77681 9.39502 -537 4 53.2972 5.98514 4.64126 3.7215 -8.75629 2.11801 -538 4 53.3251 8.87081 5.17658 4.71004 0.103302 -2.74719 -539 4 54.7439 8.12131 4.95956 10.0262 2.1061 -7.58392 -540 4 53.7752 7.60869 6.06781 -3.05466 -8.65204 35.212 -541 1 47.7159 6.1092 6.3306 31.3529 14.3598 14.0351 -542 2 46.4076 6.11425 5.7591 -25.7668 -19.0326 -13.8071 -543 2 45.4013 5.23171 6.47844 56.1675 -11.9112 16.6864 -544 3 44.23 5.34684 6.24133 -49.2229 2.39302 -4.99484 -545 4 48.3398 5.28969 6.15889 -17.2258 10.451 -1.21207 -546 4 45.9358 7.11624 5.83656 4.3919 7.44058 4.79016 -547 2 46.401 5.6982 4.25555 12.45 -16.5042 -24.1702 -548 2 46.8608 6.82251 3.28226 -4.83626 -15.1342 -13.4955 -549 2 46.0803 8.13881 3.30599 -14.5444 -4.79224 -13.1752 -550 3 44.9716 8.27119 2.67975 10.7775 -8.64163 7.28309 -551 3 46.5691 9.08454 3.95876 4.86602 16.815 8.62941 -552 4 45.3845 5.39013 3.90204 -1.72737 6.76951 8.44594 -553 4 47.0179 4.72632 4.06618 -9.2699 26.8442 8.77601 -554 4 46.8747 6.40942 2.20799 2.04532 8.89503 18.2744 -555 4 47.9008 7.08537 3.56457 7.18737 -1.18981 -5.53646 -556 1 45.8799 4.29222 7.33829 -37.7514 2.20406 -4.61566 -557 2 44.9987 3.41141 8.06424 -3.99299 1.7641 -5.76947 -558 2 44.3276 2.33248 7.21969 -45.1266 -42.7281 27.6017 -559 3 43.411 1.613 7.73718 25.6836 24.6852 -13.962 -560 4 46.8488 4.10168 7.49502 31.0353 -1.43619 1.82022 -561 4 45.5349 2.87862 8.87403 3.80662 2.65181 2.49747 -562 4 44.2009 4.01738 8.56522 2.51171 -3.43938 -1.53795 -563 1 44.7359 2.05713 5.97006 1.92732 3.23614 21.462 -564 2 44.1948 0.978467 5.13766 -26.7101 17.135 -13.9432 -565 2 44.8486 41.5478 5.5025 3.41127 -20.6454 16.5554 -566 3 46.0871 41.4431 5.57675 -14.0525 11.0231 2.35631 -567 4 45.5581 2.59183 5.73006 15.6975 -3.64086 -27.3416 -568 4 43.0338 0.980574 5.28193 28.569 -9.56263 1.83686 -569 2 44.4255 1.37435 3.62453 6.02041 -5.1027 -4.41971 -570 2 43.5303 2.62118 3.29791 4.64703 16.7196 -23.7169 -571 2 44.2051 0.148173 2.67978 -29.1583 2.83252 11.5038 -572 2 43.5747 3.10962 1.83395 1.21002 2.08355 -6.515 -573 4 45.4937 1.66977 3.44724 -0.165314 0.952935 9.41179 -574 4 43.8006 3.52551 3.92139 -2.56937 -12.5949 1.07415 -575 4 42.4611 2.43664 3.46298 -10.2855 -9.14552 12.9963 -576 4 44.5119 0.377143 1.64896 8.27723 -0.881131 -7.54742 -577 4 43.1044 41.7625 2.59144 16.8524 3.81389 6.96191 -578 4 44.7846 41.171 3.05101 -3.46686 1.83863 -12.0461 -579 4 44.5392 3.56167 1.57116 9.55733 8.13116 4.62467 -580 4 42.7809 3.86627 1.57982 6.14378 -4.69974 7.81616 -581 4 43.4757 2.31615 1.08375 -8.22918 -11.6964 -1.57482 -582 1 44.0839 40.4233 5.76821 21.932 -1.5334 -8.86254 -583 2 44.7424 39.1674 6.24443 -3.28027 29.5462 -2.23354 -584 2 45.6232 38.4648 5.15467 16.5957 -3.17533 31.1682 -585 3 45.1655 38.1269 4.0769 -9.06079 2.14789 -9.97198 -586 4 45.3594 39.5074 7.13461 -7.15079 -15.4686 -7.49065 -587 2 43.5266 38.3049 6.70081 12.2837 2.36218 -7.01546 -588 2 42.3912 38.8204 5.83129 -5.25874 0.19697 14.2242 -589 2 42.6515 40.3318 5.90174 -25.8883 17.7161 37.6601 -590 4 43.2615 38.5482 7.76954 6.63706 -13.879 -3.94164 -591 4 43.7406 37.2122 6.50504 -6.24398 7.50926 12.4246 -592 4 41.3856 38.4747 6.1895 5.24712 7.09666 -1.13826 -593 4 42.5101 38.4102 4.83081 -0.0162975 -1.57753 -20.806 -594 4 42.2783 40.7857 6.94925 18.7272 -16.9878 -38.5107 -595 4 42.0764 40.8825 5.13323 2.00122 -0.967094 -8.03005 -596 1 46.8623 38.0021 5.57674 -15.3549 -23.0767 -9.82664 -597 2 47.7161 37.0187 4.84527 -3.88045 42.2808 23.2471 -598 2 47.0384 35.8723 4.15029 10.1677 -9.37304 -39.3599 -599 3 47.4551 35.4743 3.0324 -9.4669 19.846 29.5852 -600 4 48.2252 37.6386 4.0698 7.54977 -11.2433 -2.33648 -601 2 48.6452 36.5035 5.99482 -10.0312 13.1223 -5.95218 -602 2 48.8959 37.7819 6.80046 -4.41071 -5.72741 24.5975 -603 2 47.4918 38.4151 6.80561 23.284 1.3706 -4.72721 -604 4 49.5844 36.0861 5.59811 5.91725 -9.04521 -0.913385 -605 4 48.1158 35.748 6.64071 6.83063 -0.71303 -5.46675 -606 4 49.6383 38.4449 6.34864 7.02588 7.83512 -10.7506 -607 4 49.3019 37.5753 7.85532 -11.9914 1.76609 -18.7023 -608 4 47.544 39.5162 6.85821 3.72706 6.34433 1.60956 -609 4 46.9486 38.0654 7.68542 -11.5693 -5.06488 12.3189 -610 1 46.0019 35.318 4.78064 -26.4221 -3.88232 27.7903 -611 2 45.3025 34.13 4.26579 26.8092 19.3149 11.5505 -612 2 44.4585 34.46 3.02929 16.6723 1.23881 35.6677 -613 3 44.3932 33.6565 2.12406 -6.96945 -13.3218 -23.6344 -614 4 45.6895 35.6839 5.72645 6.17072 -11.3773 -21.4598 -615 4 46.1371 33.4525 3.9443 -9.57056 -4.48549 -9.01935 -616 2 44.5851 33.4333 5.41517 7.28023 -34.3989 -9.31284 -617 2 43.896 32.1478 4.95943 -2.5072 53.7563 23.2534 -618 3 42.6929 32.0377 5.28407 -11.6877 -17.8688 -5.68187 -619 3 44.6212 31.2997 4.42805 15.8429 -32.9345 -13.4225 -620 4 43.8908 34.1037 5.87793 -28.8167 18.0933 10.1447 -621 4 45.2673 33.1449 6.25678 1.67129 3.14432 -6.05002 -622 1 43.9425 35.6996 2.93756 -0.354949 -32.7532 -51.8723 -623 2 43.3733 36.2033 1.70184 -38.6892 -13.1006 14.7431 -624 2 44.3694 36.8017 0.73913 15.0439 4.82349 -39.1461 -625 3 44.0609 36.9601 41.4463 -0.757384 -5.0254 19.6545 -626 4 44.0082 36.3398 3.67638 4.88567 37.3717 42.7902 -627 4 42.8639 35.3314 1.17484 15.8753 7.76257 0.915116 -628 2 42.1931 37.1947 1.98861 35.687 20.598 -23.7763 -629 2 41.116 36.6037 2.88066 -6.28281 10.7168 27.7809 -630 2 39.8788 37.4748 2.97821 -20.6793 -12.2331 -39.8799 -631 3 39.5744 38.0012 4.02693 -4.5695 14.1805 28.3661 -632 1 39.0796 37.534 1.86047 23.989 -9.69865 9.57867 -633 4 41.7899 37.5369 1.00167 -6.59533 -6.76427 4.06671 -634 4 42.6371 38.1477 2.39011 -7.96796 -7.2267 7.32793 -635 4 41.4745 36.4913 3.95075 -0.75248 -0.913082 -13.6466 -636 4 40.7949 35.61 2.55083 -3.16107 -12.1939 -5.02302 -637 4 39.3636 37.1043 0.951835 -4.89499 3.13933 11.6446 -638 4 38.1602 37.9899 1.92801 1.07188 2.17452 -2.18356 -639 1 45.5977 37.1878 1.1702 -15.0402 3.91697 -26.2999 -640 2 46.6124 37.7593 0.269692 0.961344 -25.1749 -6.20454 -641 2 47.1251 36.6298 41.227 -15.6894 27.1972 18.7996 -642 3 47.6617 35.6605 41.7393 11.2436 -21.3221 -9.23089 -643 4 45.7953 37.0706 2.14421 15.4189 2.49224 25.3654 -644 4 46.1246 38.4981 41.5406 -7.74237 14.7139 -7.84953 -645 2 47.8075 38.4099 1.03092 10.1012 15.6193 -18.1996 -646 2 47.4246 39.6903 1.82563 -12.4684 -22.6418 23.6998 -647 2 48.6005 40.4099 2.51691 -17.3417 -7.9082 6.23218 -648 3 49.6876 40.5582 1.97833 4.99301 -0.872474 -9.60266 -649 1 48.339 40.8761 3.75079 34.2245 13.1834 24.2049 -650 4 48.6123 38.7237 0.293834 -9.9427 -4.45455 6.13719 -651 4 48.2879 37.6501 1.66455 2.7768 -3.8165 9.90104 -652 4 46.6323 39.34 2.60232 21.0344 18.1725 -15.5096 -653 4 46.9544 40.4315 1.1644 -6.65764 6.44375 -5.56957 -654 4 47.4103 40.9551 4.17425 -6.86232 -2.61251 -1.04516 -655 4 49.1568 41.2536 4.3255 -23.3959 -10.5461 -18.532 -656 1 47.0132 36.8194 39.8944 4.79393 -10.5252 -5.84263 -657 2 47.6604 36.043 38.8342 19.1375 -30.0942 8.85154 -658 2 48.4687 37.0132 37.9763 6.82075 18.1877 -22.3602 -659 3 47.9595 37.6039 37.0009 8.77071 -9.81154 18.2462 -660 4 46.405 37.5569 39.5258 -2.34297 5.9549 -2.23138 -661 4 48.4229 35.2731 39.2798 -19.3933 25.0679 -4.92238 -662 2 46.6775 35.1997 37.9517 0.490197 24.678 -10.7229 -663 2 46.0672 34.0096 38.7198 -38.9175 -0.700818 10.3629 -664 2 46.8744 32.685 38.9073 -3.26917 9.79703 -36.9848 -665 1 47.7628 32.6295 40.0786 -15.9706 28.2316 14.6984 -666 2 48.51 31.5331 40.3435 -4.63001 14.745 41.8738 -667 1 48.7312 30.5422 39.5064 -7.34995 -4.23697 -9.55446 -668 1 48.9018 31.3819 41.635 -19.9532 28.2508 -37.0556 -669 4 47.1729 34.8887 37.0027 6.80802 -10.5296 7.48075 -670 4 45.9076 35.9114 37.5121 1.10402 -9.8189 16.5264 -671 4 45.0997 33.7597 38.1755 17.1722 -3.36537 -3.11703 -672 4 45.6001 34.3514 39.6854 13.8349 -0.884929 -1.62484 -673 4 47.4022 32.4647 37.9216 2.87405 7.70981 18.3952 -674 4 46.1271 31.862 38.9206 0.553217 -4.0431 12.8995 -675 4 47.6279 33.4362 40.8042 9.43822 -37.2826 -24.9694 -676 4 48.3342 30.5657 38.5603 0.826291 -3.97588 -2.82687 -677 4 49.185 29.675 39.7859 6.04467 -9.07236 4.91997 -678 4 48.5432 32.0104 0.443983 -2.47374 7.53927 7.97734 -679 4 49.3442 30.5519 41.958 17.8055 -32.7958 11.0172 -680 1 49.7507 37.2761 38.36 -27.9891 3.94923 -10.3626 -681 2 50.6372 38.1716 37.6465 6.90802 9.01894 -16.7299 -682 2 51.1009 37.4739 36.3314 6.00851 -0.000986305 0.302592 -683 3 51.4496 36.2941 36.3505 -3.04594 -4.29189 2.8804 -684 4 50.1774 36.6397 39.0138 14.1864 -12.0724 14.4781 -685 4 50.0595 39.0583 37.2837 -1.51256 1.6517 8.14679 -686 2 51.8464 38.6091 38.5553 2.49074 0.426256 -22.3009 -687 2 51.5192 39.49 39.8069 -13.5557 -5.73698 -8.16935 -688 2 52.7888 39.6608 40.6664 -21 22.821 44.9745 -689 2 51.0354 40.8913 39.3667 -19.684 19.0705 -14.0846 -690 4 52.5817 39.1556 37.8894 -7.88883 -2.40182 8.97054 -691 4 52.3725 37.6699 38.8321 2.26719 1.04002 8.03718 -692 4 50.6848 39.0041 40.3963 9.50705 2.70236 -0.692257 -693 4 52.9505 38.8088 41.3668 0.716139 -3.31122 -6.89789 -694 4 52.7117 40.5855 41.3722 -1.5977 -23.2904 -18.3054 -695 4 53.6872 39.819 40.0903 21.6097 1.4026 -14.7648 -696 4 51.7777 41.4333 38.7338 5.73144 0.910017 10.7761 -697 4 50.6933 41.5309 40.2327 12.7628 -5.43827 -4.45399 -698 4 50.1361 40.9136 38.7005 3.06807 -14.6998 5.44273 -699 1 51.1637 38.2069 35.1833 -8.65277 46.2898 44.1617 -700 2 51.553 37.7419 33.8846 1.56046 15.8517 -26.9219 -701 2 52.7972 38.5563 33.3946 6.24297 -42.3048 -4.64985 -702 3 52.8896 39.7642 33.5814 -6.435 17.9384 2.35192 -703 4 50.9569 39.2647 35.262 8.21378 -41.2603 -12.3383 -704 4 51.8027 36.6701 33.8819 4.46523 -10.0245 6.73196 -705 2 50.2986 37.9511 32.9329 -9.17145 -5.64023 18.3882 -706 2 49.0629 37.0889 33.4059 8.5101 -2.50878 -15.0431 -707 2 50.6601 37.6697 31.4816 -9.00198 -6.28682 -34.5666 -708 2 49.2037 35.5513 33.2317 13.0867 -6.63955 11.9256 -709 4 49.9372 39.0006 33.0238 8.27291 6.69816 -3.39278 -710 4 48.1686 37.4323 32.8001 8.11156 -5.69031 9.58675 -711 4 48.8477 37.3684 34.464 -5.28515 -5.82898 -0.156702 -712 4 49.7508 37.5287 30.8047 12.011 -0.0430796 16.0089 -713 4 51.2928 36.7446 31.376 -4.11156 8.47591 0.32382 -714 4 51.1768 38.5507 31.0175 4.51478 -6.96789 5.36543 -715 4 50.1453 35.1216 33.7014 -11.0082 12.206 -5.4516 -716 4 49.2178 35.23 32.1578 -3.59036 3.22922 4.55632 -717 4 48.3665 35.0295 33.7638 0.68062 2.42879 -7.65558 -718 1 53.772 37.8505 32.7005 11.9802 38.3584 -9.99311 -719 2 54.8892 38.4918 31.9453 -18.9337 33.3604 36.4373 -720 2 0.0457823 37.9282 30.5422 -8.24024 2.92716 -24.5162 -721 3 0.594264 36.8423 30.3259 -11.3073 1.50903 5.31397 -722 4 53.7906 36.8495 32.616 -6.44893 -30.0966 2.1434 -723 4 54.5933 39.6185 31.9763 4.67753 -27.1194 -20.6963 -724 2 1.30394 38.4484 32.6241 4.82921 -5.73508 14.5601 -725 2 2.2605 39.423 31.9346 -38.1373 19.2777 23.8899 -726 2 1.83713 40.7771 31.9484 17.1926 2.24265 -1.86924 -727 2 3.4991 39.1266 31.4137 44.2785 -3.28979 -22.8275 -728 2 2.64242 41.8019 31.4282 -29.5168 1.86603 13.0701 -729 2 4.3212 40.1796 30.8558 3.27898 -39.2743 8.81887 -730 2 3.87185 41.4777 30.8782 6.24363 43.3598 -8.15054 -731 4 1.73925 37.4095 32.5315 -6.00214 7.91305 5.68876 -732 4 1.22265 38.7505 33.7444 5.52003 -9.57077 -28.715 -733 4 0.900292 41.0813 32.4345 -2.25415 1.01323 1.36593 -734 4 3.85804 38.0586 31.4239 -1.87041 17.6471 -1.97414 -735 4 2.21075 0.929728 31.5263 16.6224 -11.4708 -8.14622 -736 4 5.34427 40.0148 30.4252 -14.7168 -7.47964 5.81345 -737 4 4.49601 0.410438 30.4759 -4.95559 -13.7664 3.94973 -738 1 54.5157 38.6773 29.5249 -27.0888 35.6462 7.20647 -739 2 54.4663 38.361 28.1069 5.2815 -2.56059 -27.0064 -740 2 53.8105 37.007 27.8285 4.1142 -30.4598 -15.4676 -741 3 54.2925 36.1623 27.0158 -8.84 24.3654 24.6709 -742 4 54.0165 39.6075 29.7175 18.6271 -30.7219 2.56864 -743 4 53.83 39.1099 27.5328 0.819814 -7.88342 20.1611 -744 2 0.845681 38.4599 27.4009 -3.37868 13.1124 0.920574 -745 4 1.3644 39.4179 27.7359 0.635395 -16.0183 -8.53916 -746 4 0.720089 38.4757 26.2839 -0.330424 7.67272 7.0695 -747 4 1.43916 37.5478 27.5772 11.0328 -1.07232 10.5421 -748 1 52.6562 36.7643 28.4919 4.43857 42.1876 29.7882 -749 2 51.8688 35.5726 28.5678 11.3762 10.3615 -9.24037 -750 2 52.1836 34.677 29.7554 -56.6515 -45.7393 26.8579 -751 3 51.2796 33.8674 30.1477 33.9368 21.5747 -13.7315 -752 4 52.2409 37.5914 29.034 7.3769 -32.5773 -16.326 -753 4 50.8037 35.9045 28.6197 0.824464 -11.9292 4.40922 -754 4 51.9818 34.9789 27.6186 -1.74208 2.17118 9.08886 -755 1 53.386 34.609 30.3327 15.9463 0.295407 3.2668 -756 2 53.8702 33.5918 31.2906 -5.336 7.3854 -1.97925 -757 2 53.2724 33.784 32.6972 3.62039 -3.18208 -20.5224 -758 3 53.318 34.8834 33.2435 -3.37109 6.20646 2.08258 -759 4 54.0584 35.341 30.1321 12.3398 9.17802 -3.54281 -760 4 53.5469 32.5903 30.928 0.510164 -2.93777 -2.78072 -761 2 0.450375 33.6574 31.3834 -19.8167 20.6669 9.28695 -762 2 1.1189 33.1041 30.1021 -5.33927 -7.82927 4.13606 -763 2 2.62926 33.3565 30.0201 27.5042 -3.46073 -5.185 -764 2 3.52676 32.4236 30.898 -7.76336 10.6891 3.26174 -765 1 4.93921 32.7908 30.8651 -15.3408 -23.1293 6.29736 -766 4 0.715906 33.1135 32.3077 13.219 -7.49284 0.339296 -767 4 0.711888 34.7596 31.5921 3.25804 -21.2431 -6.20467 -768 4 0.610971 33.6189 29.2485 6.53106 -4.93764 -4.86032 -769 4 0.94328 31.9817 29.9891 -3.372 16.4508 0.497364 -770 4 2.92569 34.3879 30.2717 -10.3735 11.8265 3.32189 -771 4 2.96748 33.277 28.9434 -5.36763 -4.46501 9.75656 -772 4 3.3856 31.3899 30.5364 6.91643 -9.08032 2.48396 -773 4 3.23325 32.4634 31.9813 -4.58699 -1.94284 -9.93441 -774 4 5.35439 32.7181 29.9584 6.30767 5.94328 -10.9381 -775 4 5.52691 32.2429 31.4849 -0.455553 -3.36681 1.56927 -776 4 5.05493 33.7218 31.1915 7.72328 25.1707 0.250012 -777 1 52.7526 32.6794 33.2917 -1.1678 -10.0217 7.16811 -778 2 52.3607 32.6823 34.7156 1.10255 -1.80451 -46.4405 -779 2 53.6298 32.9771 35.466 24.3124 -3.86391 3.03884 -780 3 54.7252 32.4235 35.2212 -23.0397 10.722 4.71956 -781 4 52.6718 31.7771 32.7765 -0.499018 10.5241 3.64804 -782 4 51.648 33.5318 34.8013 -6.43996 -0.39665 8.9378 -783 2 51.7643 31.3153 35.1205 -14.6608 -0.598675 31.299 -784 2 50.4472 31.4454 35.9643 8.77941 -15.5352 -26.1807 -785 2 50.5832 31.9625 37.3651 -2.67912 16.3525 37.5763 -786 3 49.9209 32.9494 37.7433 9.07957 -2.58057 -6.15032 -787 1 51.437 31.3297 38.2211 2.67596 1.57171 0.930055 -788 4 52.5216 30.7277 35.7054 -4.20254 0.0350677 -4.46682 -789 4 51.4878 30.6783 34.2719 3.29993 -4.42069 -15.0162 -790 4 49.9434 30.4567 35.9623 3.78404 -4.63917 10.5702 -791 4 49.6858 32.0412 35.427 2.21977 11.0074 -1.38139 -792 4 51.8063 30.3924 37.9705 2.16328 6.00798 1.3625 -793 4 51.6437 31.7399 39.1747 -6.68696 -10.5036 -22.3596 -794 1 53.5095 33.8962 36.42 -8.20166 25.4414 22.1973 -795 2 54.5747 34.3024 37.3295 -19.3274 -47.2338 19.7644 -796 2 54.3374 33.5175 38.6424 -52.3016 59.5202 -10.0971 -797 3 53.3688 33.7998 39.3891 18.863 -9.21915 -6.06634 -798 4 52.6243 34.4292 36.5865 8.7567 -9.68897 -5.69769 -799 4 0.524888 33.8606 36.995 20.2449 10.0463 -17.6441 -800 2 54.6326 35.7977 37.4305 -12.9517 47.1344 28.5316 -801 2 0.0326923 36.4499 36.0829 -2.43572 -2.53932 -10.8482 -802 2 0.0400304 37.9734 36.2703 -35.7369 26.7596 -9.32276 -803 2 1.42323 35.9178 35.6511 7.48175 21.564 37.2538 -804 4 0.37702 36.205 38.1946 -7.23177 -18.0499 -4.52301 -805 4 53.6103 36.1739 37.8346 22.3749 -7.86488 -15.795 -806 4 54.308 36.1878 35.2646 -5.73883 1.17112 4.65385 -807 4 54.1487 38.389 36.8719 12.989 -15.5349 -14.8375 -808 4 55.0091 38.5546 35.2982 1.66458 -12.2972 11.8538 -809 4 0.898146 38.314 36.8215 26.4509 7.27198 12.604 -810 4 1.38795 34.9003 35.2548 1.76467 -17.1685 3.06812 -811 4 2.15782 36.0461 36.5409 -11.2535 -11.763 -23.0993 -812 4 1.84494 36.4876 34.8385 7.70144 16.3511 -18.9114 -813 1 0.00368541 32.3928 38.6933 60.3495 -72.1401 -12.2197 -814 2 54.849 31.2911 39.6724 -12.054 11.0917 -33.5573 -815 2 0.456178 31.7903 40.9874 10.6429 2.84259 -7.8967 -816 3 1.61925 32.1816 41.0469 -1.25889 2.69502 -0.320895 -817 4 0.771148 32.2113 37.9508 -27.5595 2.34137 31.2634 -818 4 53.7516 31.0568 39.7052 4.35339 2.80588 13.4321 -819 2 0.572301 30.0297 39.0906 18.5839 -9.3637 1.30639 -820 2 0.330271 28.7129 39.848 -4.85336 -14.889 23.6916 -821 2 0.693398 28.6486 41.365 -25.7394 -2.5332 -16.7842 -822 3 54.7394 28.745 0.295995 1.88939 6.38348 7.55667 -823 3 1.88537 28.4667 41.718 12.1129 0.623711 3.73015 -824 4 1.68124 30.2872 39.0755 -12.926 -11.288 -1.20667 -825 4 0.269733 29.7427 38.025 4.32739 20.9521 12.5377 -826 4 0.909417 27.8521 39.409 -5.73579 9.2082 -7.491 -827 4 54.2152 28.4395 39.7334 16.9231 1.48772 2.1114 -828 1 54.6305 31.7883 0.132952 22.8608 6.07746 39.2243 -829 2 54.8576 32.3299 1.48573 -29.3221 31.1311 -21.4901 -830 2 1.17253 32.0229 2.2009 17.6366 -16.111 10.5973 -831 3 1.59057 32.8071 3.07156 -0.674056 0.0659302 -13.788 -832 4 53.659 31.6017 41.9208 -28.5726 -8.3455 -12.917 -833 4 54.8441 33.4787 1.30532 5.06012 -29.8204 14.0187 -834 2 53.6539 32.0394 2.47663 -0.820586 10.1398 -23.6755 -835 2 52.2239 32.3686 2.01123 21.8921 -9.62397 -13.268 -836 3 51.4302 33.0165 2.73635 3.85378 3.64717 10.9914 -837 3 51.8951 32.0293 0.84168 -3.94391 -2.23918 -4.0609 -838 4 53.7898 32.6162 3.39279 8.30271 4.42614 18.4259 -839 4 53.7249 30.9715 2.71423 -6.48233 -12.4206 11.3701 -840 1 1.80027 30.8157 2.00429 -3.41308 17.021 -11.1273 -841 2 3.01391 30.3872 2.67306 -17.4243 6.23421 51.1709 -842 2 4.3573 30.5827 2.00701 -14.1548 15.4243 -63.5733 -843 3 5.42088 30.6338 2.61698 6.51202 -0.211014 15.7475 -844 4 1.38736 30.0831 1.41283 -0.948729 3.54349 -2.60962 -845 4 3.08525 30.9412 3.69277 -1.85342 -9.762 -26.0847 -846 4 2.85031 29.3254 2.98975 11.9317 8.24793 -5.27874 -847 1 4.28888 30.743 0.620497 -12.3621 7.32386 22.4338 -848 2 5.32937 31.2764 41.6512 -13.8663 -29.5394 -9.66616 -849 2 5.57121 32.722 0.10225 -38.3787 16.5244 28.1783 -850 3 4.67744 33.4061 0.685107 26.0808 -18.0695 -15.0621 -851 4 3.36015 30.6914 0.159011 7.3551 0.286523 4.85155 -852 4 6.25759 30.6643 41.7722 1.97617 9.44883 5.82281 -853 2 4.84937 31.1813 40.1487 29.2597 0.863212 8.06821 -854 2 4.69879 29.8019 39.4857 10.4894 -21.0831 -13.1113 -855 2 5.6473 28.6668 39.9936 -13.3021 -14.9024 -16.8737 -856 1 5.27077 28.179 41.3306 -2.96519 4.49812 -11.7353 -857 2 6.06985 28.0105 0.470368 18.4061 -2.74343 27.4639 -858 1 7.404 28.2193 0.415809 -33.9112 -6.97322 0.0250223 -859 1 5.53751 27.6715 1.66745 7.41355 -4.5447 5.6764 -860 4 5.59287 31.7875 39.5584 -6.62026 -5.01092 -0.797873 -861 4 3.90042 31.6963 40.0361 -18.37 16.2558 -2.13315 -862 4 4.87993 29.9347 38.3602 -5.0628 -2.10161 17.6043 -863 4 3.66163 29.4121 39.5629 -5.01534 4.60088 1.06729 -864 4 6.67981 29.0441 39.9161 8.56645 -0.645935 3.00783 -865 4 5.57604 27.7587 39.2774 2.4211 23.1794 17.5601 -866 4 4.26853 28.0084 41.463 -5.17362 0.488763 -0.181308 -867 4 7.82192 28.2777 41.397 19.0269 3.46358 -1.03101 -868 4 7.9555 28.2212 1.28205 9.21585 -1.90571 -0.36079 -869 4 4.50489 27.4888 1.75639 19.7441 2.64647 4.92685 -870 4 6.15841 27.5559 2.53009 -21.7479 0.642981 -21.0512 -871 1 6.76075 33.214 41.6912 19.219 -12.8447 -16.8584 -872 2 7.12868 34.5749 41.8436 1.78261 35.3429 43.0116 -873 2 6.77609 35.3298 40.5962 -19.1975 -45.9981 -46.2181 -874 3 6.48326 34.7082 39.534 6.6414 26.9902 28.4778 -875 4 7.37626 32.7254 41.0127 -5.73863 2.32833 8.30529 -876 4 6.55071 35.0559 0.812315 8.37617 -12.7412 -20.2377 -877 2 8.6392 34.7953 0.238234 19.5739 7.90851 -48.6006 -878 3 9.35353 34.1854 41.0304 -12.8386 -4.95727 8.3137 -879 2 9.11551 34.1669 1.50873 -18.8724 -23.6236 42.9663 -880 4 8.9088 35.8955 0.234805 -6.25165 -9.40588 3.92441 -881 4 10.2786 34.3917 40.988 -0.40493 9.85267 11.4657 -882 4 10.1184 34.4515 1.79035 25.1513 6.04912 0.147779 -883 4 9.07131 33.0605 1.52977 2.37755 -2.72972 -9.56943 -884 4 8.50911 34.4369 2.41136 -0.948376 7.25744 -9.18832 -885 1 6.94474 36.6394 40.6556 -2.44135 26.6434 -23.8261 -886 2 6.9184 37.5467 39.5347 6.69905 -14.1713 -12.8446 -887 2 8.05389 37.1964 38.5245 -27.4859 18.9986 34.7956 -888 3 7.86013 37.2053 37.325 -9.29767 -2.30205 -27.2404 -889 4 7.0965 37.1097 41.5252 4.96112 6.67936 34.6112 -890 4 5.99819 37.3272 38.9586 -4.63141 4.06603 -3.57729 -891 2 6.96111 39.0217 40.0249 7.60343 4.99798 32.9439 -892 2 5.64771 39.5459 40.7503 13.3303 -11.7686 1.87571 -893 2 5.75985 41.0532 41.0609 20.2812 5.99168 -41.4278 -894 2 4.32816 39.2726 39.9704 18.565 3.35099 -29.4893 -895 4 7.21258 39.6788 39.2071 1.58444 12.8598 -26.2647 -896 4 7.87294 39.1662 40.7418 -24.807 -6.41168 -15.2883 -897 4 5.6203 39.0148 41.7319 -7.34537 -3.15131 1.25362 -898 4 4.91646 41.4032 41.6252 -26.0876 7.76092 9.54018 -899 4 5.84653 41.6805 40.0749 -1.44823 -14.0856 28.5036 -900 4 6.60816 41.2866 41.7276 9.52725 -0.69638 -3.08419 -901 4 4.29893 39.8385 38.99 0.215491 -3.12837 12.3269 -902 4 3.42741 39.5069 40.5265 -12.1672 8.54215 8.82184 -903 4 4.17367 38.2217 39.6869 7.24572 -5.84244 0.858739 -904 1 9.22626 36.8637 39.0427 21.4973 3.37181 48.1033 -905 2 10.3674 36.5714 38.2232 -9.10154 -9.23991 0.387697 -906 2 10.2983 35.2598 37.4643 -7.87493 -21.516 -1.82692 -907 3 11.0121 35.0941 36.4546 -10.096 5.18496 3.08952 -908 4 9.43559 37.0753 40.0799 -6.60045 -9.32212 -38.2223 -909 4 10.38 37.3229 37.4195 5.65865 10.6121 -8.5187 -910 2 11.637 36.6734 39.0312 17.5501 -7.37692 6.57672 -911 3 11.6795 35.7227 40.1079 -2.8679 20.1807 -0.19791 -912 4 11.748 37.6704 39.4409 -4.03165 17.0402 13.6797 -913 4 12.5247 36.6276 38.381 6.78129 -14.3562 -2.26856 -914 4 12.1944 34.9922 39.8075 10.5839 -13.8343 -8.97123 -915 1 9.37599 34.317 37.8723 17.0981 22.6825 36.4547 -916 2 9.03961 33.1663 37.0884 -21.5177 -32.5135 -8.8238 -917 2 8.42186 33.6216 35.772 12.1136 -61.8885 -37.6156 -918 3 8.46238 32.81 34.7849 1.32901 29.1307 35.9822 -919 4 8.95542 34.3811 38.853 10.4706 -4.46378 -29.0763 -920 4 9.93142 32.5518 36.7616 2.79547 16.9463 9.21372 -921 2 8.03197 32.1466 37.7484 3.42637 10.6841 -18.9321 -922 2 8.64707 31.2467 38.7916 -6.9544 1.67927 -4.64681 -923 3 8.29676 31.4213 39.9815 6.74685 -6.11142 9.13282 -924 3 9.44706 30.3423 38.4151 3.7337 3.36295 -6.87259 -925 4 7.50152 31.5448 36.9637 8.39997 -2.11551 6.41653 -926 4 7.19405 32.7023 38.1775 -8.25993 10.1263 10.5291 -927 1 7.75009 34.762 35.719 -22.4701 19.7147 -23.1057 -928 2 7.04455 35.3131 34.5484 -10.1936 -29.3849 23.8741 -929 2 7.86233 36.3488 33.8376 -13.0656 11.1044 -41.9487 -930 3 7.58485 36.6599 32.6528 -2.0293 -9.17756 21.4272 -931 4 7.63327 35.3235 36.5488 -2.91413 9.03335 17.0933 -932 4 6.86396 34.4501 33.8456 12.5342 10.3996 -5.08052 -933 2 5.61426 35.844 34.9306 19.6262 -1.52617 -28.8748 -934 2 4.83213 34.6653 35.4025 -10.2806 -24.7237 17.6593 -935 2 4.57558 34.457 36.7787 11.017 23.715 -9.65022 -936 2 4.42364 33.669 34.4835 -0.204454 17.9401 5.69744 -937 2 3.80293 33.3928 37.1817 -18.0339 -16.5573 23.9014 -938 2 3.6203 32.6104 34.8697 -1.59657 -1.57291 16.7967 -939 2 3.28719 32.4878 36.2185 14.3191 25.239 16.785 -940 3 2.42643 31.5967 36.7004 -21.786 -29.0921 6.36516 -941 4 5.08947 36.2348 33.9913 8.47084 3.13833 18.0937 -942 4 5.68856 36.6154 35.7126 -3.45102 11.3715 1.65586 -943 4 4.93536 35.177 37.5545 -2.85956 -5.82375 -8.46254 -944 4 4.68581 33.7849 33.4351 -1.13786 -0.0334624 -10.731 -945 4 3.5508 33.3312 38.3093 3.7661 -3.16504 -32.8067 -946 4 3.21561 31.8879 34.1609 -1.14089 -4.88721 -7.16666 -947 4 2.07822 31.0058 36.0335 4.80509 5.07869 -1.12919 -948 1 8.89276 36.9109 34.4697 3.08208 2.61779 2.42454 -949 2 9.71554 37.9518 33.9536 6.78836 41.9101 -7.41895 -950 2 8.87118 39.1918 33.5791 -2.83098 -3.29658 16.5328 -951 3 9.07345 39.7706 32.5156 6.00915 0.294316 2.75033 -952 4 9.0886 36.6939 35.4314 3.3626 -5.13227 22.9354 -953 4 10.4005 38.393 34.7625 -11.752 -18.5108 -5.62727 -954 2 10.5665 37.5273 32.7526 17.9231 -22.0125 -23.4044 -955 2 11.7038 38.502 32.4536 -20.96 9.74481 -37.2535 -956 3 11.6878 39.1949 31.3977 0.540028 -8.54016 25.273 -957 1 12.687 38.5377 33.3475 38.0496 20.2334 23.5086 -958 4 9.97947 37.4403 31.7814 1.01798 2.165 18.3599 -959 4 11.0193 36.505 32.8955 -2.74071 8.1052 0.988861 -960 4 12.6531 37.864 34.1655 7.32082 17.5294 -13.3715 -961 4 13.4532 39.3055 33.2787 -30.6572 -33.7139 4.421 -962 1 7.93658 39.5767 34.4996 32.6534 -23.6413 -9.43678 -963 2 7.20273 40.8089 34.5743 -2.74612 21.1773 -15.346 -964 2 8.21766 41.8982 34.9197 -3.45605 -13.7782 10.2915 -965 3 8.98784 41.7778 35.8832 -3.40272 -3.46005 -6.10842 -966 4 7.93188 38.9898 35.3424 -7.46187 6.56739 7.86278 -967 4 6.79415 41.087 33.5295 1.97546 -9.26453 20.6229 -968 2 6.06472 40.6271 35.6481 -5.08297 -2.08213 -22.9213 -969 2 4.90833 39.9858 34.8157 -12.6977 -10.7104 -3.72739 -970 2 5.64222 41.9226 36.403 -2.05312 -2.0705 -19.9517 -971 2 3.84054 39.2603 35.6406 -0.0147652 -3.33058 30.6695 -972 4 6.3943 39.8459 36.3734 2.85979 7.06395 10.3389 -973 4 5.33061 39.1839 34.1245 -4.62997 12.2623 4.99778 -974 4 4.37584 40.73 34.1591 8.26763 -2.20969 2.2716 -975 4 4.92993 41.6478 37.2106 -0.0042749 6.0371 4.19307 -976 4 5.15795 0.778755 35.7389 -1.27911 -10.984 2.34352 -977 4 6.51935 0.549814 36.8166 0.412823 -4.00159 10.9885 -978 4 3.21428 39.9846 36.2492 8.55414 -9.22464 -7.99451 -979 4 4.28582 38.4972 36.3757 -6.36125 15.4526 -14.7269 -980 4 3.14756 38.696 34.9847 -1.95473 -0.292674 -1.44435 -981 1 8.25206 1.08297 34.1638 31.3741 38.5442 9.59718 -982 2 9.18814 2.19093 34.4552 -11.7272 -14.356 -0.722089 -983 2 8.45749 3.48131 34.8023 4.76941 7.21795 3.77261 -984 3 7.24176 3.59586 34.6101 4.23254 1.41941 3.46139 -985 4 7.75397 1.25241 33.3001 -16.6469 -12.6897 -14.3012 -986 4 9.75614 1.90919 35.3591 7.11639 4.99627 7.91164 -987 2 10.1452 2.40125 33.2642 -9.36205 3.53781 1.41258 -988 2 11.145 1.26701 33.0621 15.3724 -18.5317 -10.2549 -989 2 12.3408 1.2215 34.0193 -34.6799 -20.8737 -4.25674 -990 3 13.4283 1.6066 33.6334 28.2263 9.73281 -4.88467 -991 1 12.1185 0.540183 35.1633 28.8031 2.35628 29.4382 -992 4 10.7148 3.34616 33.3936 1.59432 0.534457 -2.79864 -993 4 9.49714 2.55965 32.3759 6.01649 -0.268224 -5.10448 -994 4 11.6127 1.34439 32.0577 -0.769775 9.57011 -1.56393 -995 4 10.6933 0.251936 32.9886 -5.52334 3.35231 7.85959 -996 4 11.2139 0.219277 35.5156 -12.526 -0.0546681 -6.86711 -997 4 12.9016 0.455342 35.8573 -9.00019 3.15098 -17.6728 -998 1 9.24699 4.48326 35.2867 7.50516 -22.9453 -9.87373 -999 2 8.79457 5.81029 35.6553 19.4094 -0.44208 23.4194 -1000 2 7.94193 6.35186 34.5098 -28.0836 13.7832 22.6841 -1001 3 8.26577 6.15625 33.3485 3.32417 -1.59684 -17.5239 -1002 4 10.2626 4.25405 35.3107 -8.01304 16.2193 5.9612 -1003 4 8.1894 5.68577 36.5846 -11.6257 -0.00282829 -7.04897 -1004 2 9.97767 6.74716 36.1433 -23.7266 14.1696 -20.2452 -1005 2 11.1395 6.93836 35.1562 2.17384 -4.68321 -25.171 -1006 2 12.442 7.40754 35.8023 6.89417 23.6707 25.6501 -1007 2 12.3585 8.87197 36.3546 -17.7601 7.18701 6.16378 -1008 1 13.652 9.40345 36.7619 -5.05233 -10.0697 25.3038 -1009 4 10.4674 6.41708 37.0624 -6.17454 -12.8958 16.6295 -1010 4 9.46609 7.72624 36.4439 19.6997 -12.4825 -9.52898 -1011 4 10.8586 7.67723 34.3661 -2.31205 -2.27426 2.47252 -1012 4 11.3956 5.98923 34.5935 -8.15618 9.36142 7.97067 -1013 4 13.285 7.3766 35.0989 4.02069 -2.74272 -14.2107 -1014 4 12.7725 6.74228 36.6382 -4.94702 -0.810609 -4.3443 -1015 4 11.6162 8.97546 37.2517 21.5709 -5.37851 -23.6156 -1016 4 11.9848 9.59279 35.5592 1.32622 -13.234 7.43529 -1017 4 13.5097 10.3531 37.0548 1.1249 12.5728 4.15723 -1018 4 14.3076 9.4933 35.9914 2.38442 -5.54985 1.16984 -1019 4 14.0989 8.9471 37.5942 -8.28554 10.0467 -28.7492 -1020 1 6.74258 6.95961 34.8453 13.8439 -7.08515 -31.5666 -1021 2 5.70412 7.47847 33.9372 22.4359 17.1833 28.8896 -1022 2 4.73468 6.47268 33.3926 -37.2702 -51.3286 -21.7325 -1023 3 3.66084 6.82477 32.8505 20.0183 9.28716 8.38675 -1024 4 6.50761 7.12516 35.8163 -0.959582 1.3178 20.8718 -1025 4 5.07512 8.17388 34.5809 1.06569 -12.1955 -8.24357 -1026 2 6.27511 8.35576 32.8097 23.4106 2.51452 -13.5767 -1027 2 6.97942 9.67377 33.2004 -16.9954 14.0421 10.4255 -1028 2 6.10535 10.8129 33.826 12.866 -26.3315 -27.4761 -1029 3 5.32563 11.4369 33.048 -2.57309 4.89094 -0.177716 -1030 3 6.28787 11.1355 35.0235 5.56298 3.82152 16.5631 -1031 4 5.49496 8.55729 32.0786 -16.2509 9.70978 -5.42728 -1032 4 7.00993 7.79082 32.1666 -6.62982 -1.98309 13.432 -1033 4 7.44051 10.1227 32.2823 5.63402 -3.39012 2.91122 -1034 4 7.79617 9.4262 33.9151 4.88029 0.56984 -5.69246 -1035 1 4.9985 5.11713 33.407 24.659 21.8647 21.6253 -1036 2 4.05493 4.11234 32.9569 -19.5991 11.2557 -30.6753 -1037 2 2.66349 4.36425 33.564 5.77052 11.5327 33.941 -1038 3 2.61183 4.63212 34.7889 -10.6254 -2.1096 -24.9185 -1039 4 5.90798 4.72579 33.7623 -18.8375 16.0079 -6.75199 -1040 4 3.94963 4.2178 31.8123 4.18537 -9.18741 21.4869 -1041 2 4.52113 2.73738 33.4375 8.25229 -17.2331 29.0433 -1042 3 5.75234 2.38881 32.7881 -21.5054 -2.62865 -12.7372 -1043 4 3.76903 1.95227 33.2696 -3.85539 -5.9091 -13.5606 -1044 4 4.62925 2.69715 34.589 6.20333 6.93314 -25.3828 -1045 4 6.43526 2.61043 33.3995 7.46021 4.72267 11.925 -1046 1 1.55191 4.21884 32.8032 -14.0425 -5.15851 -21.6842 -1047 2 0.161375 4.25438 33.2368 -9.40026 13.4655 23.096 -1048 2 54.692 2.80115 33.3646 18.1492 -1.83923 -37.1888 -1049 3 54.7885 2.04564 32.3679 -9.76904 2.34815 11.9713 -1050 4 1.58614 3.87283 31.8209 11.2241 6.42129 12.946 -1051 4 0.0932821 4.78062 34.2407 6.57702 -9.00044 -6.29593 -1052 2 54.1421 5.03026 32.3092 -30.8516 -27.3257 32.8914 -1053 3 54.4529 6.38645 32.3432 43.6526 11.7784 12.1317 -1054 2 52.6693 5.00292 32.8811 18.0931 2.75777 -15.9968 -1055 4 54.1554 4.62002 31.3044 4.18983 -2.87474 -22.2473 -1056 4 53.8639 6.90955 31.8518 -25.2917 13.9269 -18.693 -1057 4 52.66 5.46781 33.8932 -7.48107 5.39969 -2.18241 -1058 4 52.249 3.98991 33.0062 0.231344 -5.48034 -3.27193 -1059 4 51.9963 5.5356 32.1423 1.66512 -1.40627 14.088 -1060 1 54.1705 2.41097 34.5199 1.80418 26.5965 31.5441 -1061 2 53.4771 1.1604 34.7223 -23.5881 -17.4143 30.2256 -1062 2 51.9672 1.43692 34.4286 45.4706 11.6959 19.6168 -1063 3 51.5098 2.51334 34.8139 -14.0548 -1.70012 -4.22959 -1064 4 54.1449 3.13072 35.3168 -2.84084 -28.6208 -21.3152 -1065 4 53.8073 0.317305 34.0552 7.54144 10.0832 -0.542806 -1066 2 53.6466 0.727247 36.2732 15.0023 -0.977243 -19.0787 -1067 2 0.11045 0.778115 36.8855 -3.47233 23.3808 -12.4462 -1068 2 0.174657 0.0352411 38.2454 9.71436 -6.65086 -1.81426 -1069 2 1.19132 0.222888 35.8995 6.11034 15.7938 3.95568 -1070 4 53.2393 41.6189 36.352 -4.11551 -11.0062 3.39296 -1071 4 53.0266 1.35722 36.9407 -10.5209 2.31976 -3.99924 -1072 4 0.276909 1.89779 37.0745 11.3679 -17.77 -1.06189 -1073 4 54.361 0.442618 38.9125 4.10216 -8.97134 2.26246 -1074 4 1.16474 0.174268 38.7716 -10.2453 4.64912 -5.91146 -1075 4 0.0894693 40.827 38.1128 -8.07449 10.5575 2.47406 -1076 4 2.18017 0.0911741 36.3628 0.498668 -8.86502 15.8712 -1077 4 1.51082 0.946112 35.1046 -21.6742 -5.82018 -4.77892 -1078 4 0.87048 41.1455 35.5035 3.84873 -0.316194 -7.96637 -1079 1 51.2572 0.510776 33.7869 -35.0849 -22.21 -18.422 -1080 2 49.7991 0.651464 33.5457 -7.89552 -1.42073 2.85742 -1081 2 49.1064 41.7127 34.6422 20.8091 24.7993 -30.4476 -1082 3 49.3211 40.5176 34.6928 0.936017 -16.9834 6.81615 -1083 4 51.5685 41.4333 33.6514 6.90564 11.6478 3.53197 -1084 4 49.4699 1.73569 33.6536 7.71362 -9.58165 1.5915 -1085 2 49.2914 0.124722 32.1435 -1.6477 0.542595 21.3952 -1086 2 49.5957 1.07684 31.016 -40.6033 -15.585 26.437 -1087 1 48.7294 1.99918 30.4836 -27.6566 13.4748 -4.54446 -1088 2 50.7297 1.21695 30.3262 36.7247 10.1326 -33.1818 -1089 2 49.2902 2.59089 29.4013 15.6758 12.8861 -16.3634 -1090 1 50.5605 2.13547 29.3267 -27.6128 -3.77706 23.4645 -1091 4 48.1729 41.8384 32.2733 14.3125 6.04861 -12.1255 -1092 4 49.7214 41.0254 31.9181 -0.443629 4.48635 2.11286 -1093 4 47.7408 2.2006 30.8029 20.1006 -6.4749 -2.25561 -1094 4 51.6449 0.698065 30.4056 15.084 -12.5894 5.57169 -1095 4 48.9104 3.2954 28.6425 -5.47018 -10.6135 19.6435 -1096 4 51.2563 2.40703 28.6421 12.9903 7.46191 -13.5301 -1097 1 48.3611 0.457254 35.523 -13.4783 35.8963 4.98689 -1098 2 47.6684 41.7265 36.6028 -12.609 2.82517 16.7739 -1099 2 46.2613 41.336 36.1362 14.2498 9.86212 -6.63619 -1100 3 45.3696 0.249228 35.9008 11.2544 -8.11188 8.40093 -1101 4 48.1527 1.47601 35.3837 2.04907 -15.0615 5.33592 -1102 4 48.2568 40.8085 36.8471 -2.89667 -2.02658 5.80089 -1103 2 47.5596 0.692305 37.8969 5.07609 12.8861 -15.4572 -1104 2 46.7247 0.067171 39.0652 -23.3887 -7.36646 -24.3057 -1105 2 47.033 40.4837 39.4166 -14.2982 16.8046 -18.6717 -1106 2 46.9311 0.907751 40.3269 20.2628 20.9695 31.7148 -1107 4 47.0803 1.72619 37.5586 18.4264 -28.4903 17.3716 -1108 4 48.6288 0.838001 38.2574 -15.841 5.68773 -4.62102 -1109 4 45.6307 0.107149 38.6982 15.4635 0.946246 17.2142 -1110 4 48.0197 40.3992 39.8616 17.8935 -6.94949 10.1905 -1111 4 47.0012 39.8155 38.524 1.84183 3.03864 3.36861 -1112 4 46.2605 40.0937 40.1174 3.5183 -0.242765 2.2201 -1113 4 48.0596 1.05972 40.5786 -27.9597 -7.64804 -5.61245 -1114 4 46.4366 0.492644 41.2461 4.13191 -4.52617 -8.48469 -1115 4 46.5029 1.93558 40.2678 1.33797 -2.98423 -8.86627 -1116 1 46.1363 40.0225 35.9719 -11.8784 -48.163 0.632693 -1117 2 44.9067 39.2611 35.7716 22.3959 0.0668878 -14.2888 -1118 2 44.4049 38.8629 37.1725 -35.2322 11.6067 -22.5418 -1119 3 45.1472 38.486 38.0617 14.0918 -2.68919 9.70234 -1120 4 46.908 39.3425 36.1226 1.34088 13.782 2.29065 -1121 4 44.2497 39.8817 35.1331 -17.245 4.97255 12.4072 -1122 2 45.2366 37.985 34.8925 -4.99104 -6.23114 -9.17669 -1123 2 44.0069 37.0072 34.8313 5.26574 11.342 7.98842 -1124 2 45.6195 38.3915 33.4226 -3.76358 -20.0352 6.70883 -1125 4 46.1177 37.4383 35.3134 -3.76426 -1.15462 7.05426 -1126 4 43.5316 36.9313 35.8696 0.358942 -6.34703 -24.4349 -1127 4 44.3242 35.9956 34.5249 4.20531 -7.16171 2.34616 -1128 4 43.2753 37.3126 34.0403 -3.87397 3.42825 10.5933 -1129 4 46.6384 38.8467 33.4221 -3.79452 2.69366 -2.61982 -1130 4 44.9004 39.1304 33.0043 0.823619 -0.608417 -3.73086 -1131 4 45.6564 37.4663 32.7381 0.0287792 19.4258 11.3413 -1132 1 43.0561 38.9062 37.36 16.7964 -0.846157 38.4014 -1133 2 42.4272 38.5172 38.6279 -14.5421 -18.7427 13.0828 -1134 2 41.8753 37.0763 38.5124 -8.78692 12.5845 -64.2445 -1135 3 41.466 36.6885 37.3717 6.29707 6.96761 32.6735 -1136 4 42.3774 39.0214 36.6331 -15.2734 7.16413 -28.2079 -1137 4 43.1919 38.4467 39.4108 16.1917 0.0561369 8.47296 -1138 2 41.3404 39.5151 39.1514 -18.2527 2.1619 5.40726 -1139 2 42.0205 40.8503 39.6333 -29.5812 13.2835 -20.5362 -1140 2 41.0689 0.171231 39.4112 30.2059 17.4331 -9.29433 -1141 2 42.4678 40.816 41.1078 15.9246 -23.8206 -10.1516 -1142 4 40.688 39.0893 39.9799 16.7303 0.907162 -6.07322 -1143 4 40.5588 39.6983 38.3606 15.4269 0.857054 0.728379 -1144 4 42.8535 41.0549 38.9416 17.5291 -0.3509 1.61726 -1145 4 41.6271 1.1561 39.6676 -14.9721 -22.7636 -0.520954 -1146 4 40.1564 0.111331 40.0029 -13.6089 -0.269988 10.9836 -1147 4 40.76 0.320829 38.3386 1.94315 -8.64923 8.74761 -1148 4 41.6626 40.4848 41.7802 -9.99726 5.60483 6.07701 -1149 4 42.8258 41.8281 41.4135 4.90552 -5.57863 6.49728 -1150 4 43.2679 40.0127 41.241 -4.54696 19.1865 -0.92221 -1151 1 41.8233 36.2733 39.5754 -3.61756 -11.0936 16.9633 -1152 2 41.1922 34.957 39.6399 -10.4088 -17.6704 -50.7121 -1153 2 39.8412 35.0841 40.3193 -0.437683 4.39576 10.763 -1154 3 39.8144 35.4746 41.4864 -9.76 5.96233 -2.547 -1155 4 42.2323 36.5766 40.4577 6.86651 4.46574 10.4638 -1156 4 40.9934 34.6386 38.4963 8.65196 -1.15376 42.0164 -1157 2 42.0562 33.8903 40.4247 20.8855 33.0106 -9.02378 -1158 2 41.3005 32.6543 41 38.0556 15.2529 -12.1112 -1159 2 42.2217 31.3951 41.1067 -29.8496 -30.3433 -13.4218 -1160 1 43.3285 31.549 0.111927 13.7517 39.8644 23.5527 -1161 2 44.3839 30.7268 0.286736 21.6234 19.2182 17.9174 -1162 1 44.681 29.6113 41.5428 -25.8767 -16.3024 -25.7307 -1163 1 45.3493 31.1499 1.13058 -39.3833 23.49 -6.35183 -1164 4 42.617 34.5166 41.192 -12.3652 -23.3828 3.531 -1165 4 42.8948 33.5841 39.7601 -4.64767 -6.80459 -5.17496 -1166 4 40.4819 32.4474 40.3056 -13.8786 -11.9041 -4.8646 -1167 4 40.8645 32.9834 0.0421702 -8.7777 -8.2778 13.4879 -1168 4 42.5872 31.067 40.0872 -0.36901 12.0823 9.30135 -1169 4 41.553 30.5032 41.4129 16.6518 20.7036 2.18161 -1170 4 43.3615 32.497 0.627799 -1.11121 -36.4642 -14.6418 -1171 4 44.0326 29.3067 40.7749 11.9664 -0.606259 12.9296 -1172 4 45.4908 28.9966 41.7635 -4.5997 7.04477 0.652143 -1173 4 45.2947 32.0222 1.6989 -3.32167 -9.1207 -8.17541 -1174 4 46.1369 30.5772 1.3332 29.28 -20.6173 7.21336 -1175 1 38.7318 34.7203 39.6307 -5.56998 -4.40152 -32.2775 -1176 2 37.3555 34.7738 40.1542 17.1032 1.0045 -6.37855 -1177 2 37.2353 33.667 41.1913 -33.3614 37.0741 40.0449 -1178 3 37.7005 32.5636 40.9891 18.731 -32.0974 -3.65368 -1179 4 38.8335 34.3404 38.6486 -6.51334 12.5121 23.5529 -1180 4 37.2672 35.7762 40.6273 -9.086 1.46109 5.84779 -1181 2 36.2453 34.5638 39.0845 -6.93832 -9.37108 -7.97374 -1182 2 36.1701 35.614 37.9414 8.91404 15.2365 -6.3275 -1183 2 35.3527 35.0344 36.7472 39.8054 8.21108 -27.9 -1184 2 35.4841 36.9314 38.4139 -18.287 13.7727 -16.8718 -1185 4 35.232 34.5024 39.5744 7.45292 -0.257102 0.0904576 -1186 4 36.3852 33.5433 38.6164 0.781265 7.17557 6.89015 -1187 4 37.2115 35.9047 37.5843 -11.2451 -10.8797 5.10717 -1188 4 35.5662 35.6385 35.778 -16.1675 -5.48794 25.897 -1189 4 34.291 34.967 37.0013 -15.7304 -0.876038 -4.35202 -1190 4 35.7074 34.0135 36.4456 -4.10332 3.28733 9.08934 -1191 4 35.4655 37.7439 37.5577 -4.97646 -27.0735 23.6494 -1192 4 36.0148 37.4196 39.237 12.1669 1.46201 8.99598 -1193 4 34.4369 36.7462 38.8365 16.8945 3.16641 -16.172 -1194 1 36.5334 33.9935 0.435925 10.1465 7.38421 -15.9691 -1195 2 36.4058 33.2568 1.6875 16.4821 -29.3274 -13.0782 -1196 2 35.1468 33.6833 2.42741 -3.52585 26.4938 2.22063 -1197 3 34.7699 34.8785 2.50349 9.50092 -20.8144 -9.83338 -1198 4 35.9506 34.8486 0.439937 7.33038 -6.12466 -5.51472 -1199 4 36.3499 32.1247 1.42412 1.62075 26.2077 7.36918 -1200 2 37.675 33.5505 2.58336 -0.681506 -6.35683 7.58589 -1201 2 37.7854 32.6927 3.8625 18.6921 -17.668 32.0141 -1202 2 39.0575 32.9332 4.76873 14.2724 -20.5826 -30.9069 -1203 1 39.1289 34.2491 5.33109 11.0713 19.2422 13.5273 -1204 2 40.0441 34.6938 6.2528 -38.5124 5.77538 -21.346 -1205 1 41.0523 34.0015 6.75388 -9.3068 -30.315 -40.8639 -1206 1 39.7573 35.8959 6.75045 4.65044 -37.6482 -19.533 -1207 4 37.7117 34.6025 2.94212 -4.78803 6.98284 -11.1897 -1208 4 38.6033 33.3783 1.98429 -1.50456 2.19712 -0.683264 -1209 4 37.8193 31.5994 3.65006 -4.42508 0.799529 -11.9295 -1210 4 36.9318 32.7949 4.56147 -11.5542 5.52665 -5.70323 -1211 4 39.9727 32.6563 4.13477 -10.3426 12.9457 13.0222 -1212 4 39.0991 32.232 5.62646 -6.41615 -9.9444 -1.6393 -1213 4 38.3112 34.8566 5.12728 9.08197 -0.1797 3.06874 -1214 4 41.338 33.0965 6.26824 1.29043 26.2885 21.8424 -1215 4 41.5567 34.3995 7.53172 18.6054 -2.34736 15.9895 -1216 4 38.9283 36.4191 6.51463 -17.6749 8.57537 -7.4588 -1217 4 40.3535 36.2619 7.44459 24.2502 25.7988 36.1589 -1218 1 34.4423 32.7029 2.99518 -5.91218 -18.2551 8.17758 -1219 2 33.2643 32.9205 3.78866 2.14491 3.18155 15.0212 -1220 2 32.3114 31.74 3.93685 27.6029 1.93064 -50.2862 -1221 3 31.6521 31.6162 4.95167 -20.1995 -6.42992 23.3772 -1222 4 34.7506 31.7123 2.9878 2.11082 4.57648 -1.08475 -1223 4 33.5885 33.2179 4.82725 -4.56531 -3.45872 -11.3922 -1224 4 32.6993 33.791 3.40271 -6.19117 1.50996 -1.33542 -1225 1 32.2733 30.8792 2.86255 -3.44833 -0.807911 26.2314 -1226 2 31.5067 29.6456 2.87911 -22.6819 -12.0155 6.38652 -1227 2 32.0275 28.5204 1.99364 -17.4826 -15.7648 -26.1521 -1228 3 31.24 27.9052 1.1757 18.2868 13.9435 17.0259 -1229 4 32.9257 31.0189 2.07167 -6.99587 -10.4877 -2.31778 -1230 4 31.4409 29.1882 3.92659 1.7726 14.0477 -11.6562 -1231 4 30.4172 29.8482 2.57519 20.7941 0.876843 7.98191 -1232 3 33.2432 28.1769 2.02662 6.75216 10.2675 5.6015 -1233 6 29.6689 33.0345 2.6027 6.39732 3.7635 -6.59735 -1234 4 28.7656 33.0857 2.95028 -0.371973 -14.4593 -6.85361 -1235 4 29.8153 32.1814 2.14015 -8.59972 11.6466 4.8732 -1236 6 1.91326 24.7635 28.0772 5.65317 -6.35183 16.4854 -1237 4 1.01929 24.4316 28.2568 3.94453 1.46201 -0.938269 -1238 4 2.46517 24.4471 28.8255 -6.59296 2.11781 -11.8027 -1239 6 8.98979 35.4216 7.06427 2.13264 0.908259 -3.07356 -1240 4 8.22375 36.0041 6.95701 -0.608539 -3.26387 0.365744 -1241 4 9.74616 35.991 6.87666 4.70766 2.91314 -0.442423 -1242 6 37.9357 35.2342 23.5273 -23.102 9.18642 19.8247 -1243 4 37.5041 35.2968 22.6705 0.513901 -3.82007 -8.89977 -1244 4 38.8432 35.0218 23.4038 20.8563 -8.17935 -11.4372 -1245 6 11.3793 34.6137 20.3253 14.1507 4.32837 -4.20952 -1246 4 10.4755 34.624 20.6003 -22.0831 6.77293 1.73618 -1247 4 11.7264 33.9016 20.8561 13.9299 -11.0914 4.04985 -1248 6 3.06607 13.1144 13.5167 22.577 18.8722 18.6067 -1249 4 2.20388 12.8262 13.8046 -7.02328 -4.57126 0.810516 -1250 4 3.32154 13.8092 14.1761 -2.44089 -14.0351 -15.8923 -1251 6 9.17443 22.3777 24.8954 -7.42914 3.56866 8.74917 -1252 4 9.07626 22.0242 24.0039 2.26474 -2.4656 -3.7019 -1253 4 8.26912 22.4958 25.2295 3.15193 -1.43545 -3.27774 -1254 6 31.1464 36.1236 7.45234 10.6607 -18.1227 -24.2194 -1255 4 30.9334 35.2222 7.12747 -5.34615 12.6105 12.538 -1256 4 31.8314 36.3443 6.79825 -5.43643 8.62165 8.26122 -1257 6 20.3227 0.172698 30.1419 10.3105 -3.05703 7.76208 -1258 4 20.0388 1.0684 29.8874 5.3247 -3.32009 0.781739 -1259 4 21.2583 0.228399 30.4322 -11.2768 6.47679 -5.28094 -1260 6 32.6859 3.01778 5.15829 -10.6028 -19.0303 43.6625 -1261 4 32.0356 2.3058 5.02019 7.54008 9.83835 -8.28794 -1262 4 32.7128 3.00557 6.15578 5.12118 6.62375 -23.7252 -1263 6 26.2374 8.27856 11.5971 17.869 0.788073 20.0593 -1264 4 26.2346 7.39991 12.0216 -0.142457 7.42091 -4.28305 -1265 4 26.8978 8.79254 12.1302 -17.5189 -15.6641 -18.5798 -1266 6 1.09614 20.2561 0.875192 -22.9747 0.467748 19.1373 -1267 4 0.851949 19.3199 1.10255 19.4844 20.3298 -11.3195 -1268 4 1.85437 20.3448 0.297385 12.1513 -16.76 -9.59627 -1269 6 29.1514 22.9126 1.42851 -3.57267 15.5796 12.2113 -1270 4 28.6966 23.7416 1.67141 5.52941 -12.1705 -9.88265 -1271 4 29.6634 22.7027 2.22543 0.165437 -2.26551 -2.85175 -1272 6 34.1399 34.826 6.47271 -4.00425 12.5535 -7.93856 -1273 4 34.8635 34.3401 6.10458 13.259 -3.54932 -9.87122 -1274 4 33.9387 34.3337 7.25184 -8.28913 -2.66912 16.7304 -1275 6 25.1643 37.1931 26.5228 17.2229 -22.0393 -23.1844 -1276 4 24.6935 37.7676 27.1042 -4.31343 22.2846 18.4719 -1277 4 26.0117 37.6203 26.271 -7.79876 5.52479 6.28113 -1278 6 14.5333 22.2337 15.6719 -21.8235 -40.5779 4.16881 -1279 4 14.0435 21.3187 15.7268 23.5152 50.9834 -4.51283 -1280 4 14.2451 22.7392 14.8947 -1.224 -10.8945 3.63574 -1281 6 2.86145 5.86342 4.09514 -12.0928 12.5672 -7.55007 -1282 4 3.31871 5.53612 4.87755 -0.114002 3.3263 11.1441 -1283 4 2.36891 6.69134 4.30817 11.5092 -15.7361 4.93451 -1284 6 27.6072 26.7133 22.7037 11.3111 -21.4893 35.9413 -1285 4 26.8221 26.1673 22.7712 -7.10606 -4.70529 -2.97044 -1286 4 27.5145 27.2572 21.9514 -10.0855 20.8317 -32.7258 -1287 6 17.7799 0.609907 22.4001 -5.17757 10.6635 4.04288 -1288 4 17.0763 0.657064 23.0885 11.5181 4.04392 -9.91171 -1289 4 18.0806 1.5364 22.261 -7.85301 -10.5281 2.59652 -1290 6 8.08893 9.42761 10.5595 3.55537 5.25916 40.324 -1291 4 7.89361 10.322 10.3179 -9.19974 15.7377 -19.3495 -1292 4 8.16563 9.56196 11.5399 2.2102 -21.2534 -20.7584 -1293 6 15.3508 8.71886 30.755 5.09068 -14.416 21.7005 -1294 4 15.721 8.98141 29.9127 -5.17651 10.4904 -11.2194 -1295 4 14.5411 9.19598 30.997 6.64715 3.62724 -9.30987 -1296 6 11.0273 17.2714 37.5546 -8.62993 4.63856 -3.16721 -1297 4 10.646 18.1523 37.5049 13.3861 11.3255 -4.88271 -1298 4 10.2437 16.8378 37.8681 -2.55755 -24.0409 7.53141 -1299 6 42.0954 25.1585 20.3881 14.6842 1.84925 -24.6227 -1300 4 41.6997 25.8318 19.7943 -2.16553 -3.48259 16.6789 -1301 4 41.6994 25.1952 21.2528 -9.02961 7.39914 10.888 -1302 6 25.8656 4.70522 33.8434 4.94337 -17.9304 30.0995 -1303 4 25.7948 4.41246 32.9437 -1.56424 4.53154 -20.9619 -1304 4 25.7821 5.65919 33.9019 -2.93726 10.638 -9.31877 -1305 6 28.7565 10.7943 24.343 5.31048 -5.66707 -17.5237 -1306 4 29.0395 10.691 25.2776 6.61806 -8.7001 -20.887 -1307 4 29.3174 10.2678 23.7025 -8.86987 6.64124 26.5787 -1308 6 5.00601 41.813 11.1 6.11697 -35.3303 28.6791 -1309 4 5.97939 41.6679 11.0741 -12.7816 8.03831 -2.02432 -1310 4 4.68345 41.1078 11.7429 5.5471 25.1349 -25.8779 -1311 6 51.7607 12.785 30.1531 41.9873 7.8243 6.58168 -1312 4 51.5044 13.1989 29.3224 -3.76645 3.26875 -7.63234 -1313 4 52.7548 12.9452 30.2104 -29.821 -7.22149 1.35463 -1314 6 7.60527 6.19156 6.53697 16.5093 0.883216 -0.386471 -1315 4 6.7728 6.50088 6.91441 -4.77803 -9.70632 -1.71599 -1316 4 7.48617 5.31021 6.15237 -11.2115 3.19853 1.4886 -1317 6 14.6639 26.9856 30.1439 5.75321 15.8705 11.2484 -1318 4 14.5566 27.0259 31.1175 -3.12227 -7.05885 -13.9758 -1319 4 15.1715 27.7926 29.9326 -6.11328 -7.83436 0.701957 -1320 6 15.3386 3.73742 21.1629 -49.5233 -4.42818 1.41573 -1321 4 14.7513 4.15862 21.8308 22.5595 -2.74077 -5.2282 -1322 4 14.679 3.20837 20.6508 28.7222 9.19721 3.95726 -1323 6 18.6168 30.4391 6.46727 22.6827 -23.6706 30.2016 -1324 4 19.0357 29.7477 7.08277 -19.2097 26.0479 -21.7287 -1325 4 19.3376 31.0911 6.37388 -10.7119 -2.89972 -1.77141 -1326 6 40.7683 1.30949 12.8061 -7.58564 4.37034 -9.51004 -1327 4 39.8743 1.70123 12.8539 8.02325 -2.8267 0.614513 -1328 4 41.1302 1.62292 11.9594 1.79027 -4.37486 1.66609 -1329 6 17.747 20.7401 41.5828 -14.5708 23.9699 -22.25 -1330 4 16.8287 21.1121 41.5273 18.852 -12.8662 8.2158 -1331 4 18.269 21.3043 40.983 -0.296974 -7.34806 11.4382 -1332 6 20.4522 2.1467 12.3338 -13.8993 16.4183 -18.7538 -1333 4 19.8428 1.38545 12.4588 7.32118 14.6694 -7.56396 -1334 4 20.1591 2.61844 11.4836 4.96023 -26.6086 29.2353 -1335 6 9.8437 37.1731 18.0697 32.5344 -3.69518 -7.02483 -1336 4 9.9915 37.607 18.9153 -11.6933 2.16478 7.61773 -1337 4 10.7629 37.1686 17.7045 -22.2666 -4.61022 -1.39483 -1338 6 22.8273 7.39987 18.8956 -5.5011 7.28813 -36.492 -1339 4 23.2632 7.84344 18.1165 -7.98371 -8.25387 20.5209 -1340 4 21.8866 7.2843 18.6392 14.3432 0.686453 4.84686 -1341 6 12.8601 6.85899 39.0577 6.92589 -13.3495 -12.6124 -1342 4 12.2887 7.60854 39.1608 -14.8411 14.7282 0.271429 -1343 4 13.3423 6.79713 39.8797 5.00888 -0.905409 12.2129 -1344 6 10.1643 2.40912 23.2548 -13.4149 21.1074 -1.06732 -1345 4 10.2774 2.03439 22.3894 8.18098 -13.9841 -15.6202 -1346 4 9.49692 3.09648 23.049 6.99386 -4.39158 13.7206 -1347 6 12.5495 20.2147 19.5723 7.26787 8.21028 -18.3895 -1348 4 11.6895 19.7983 19.735 -1.5185 0.18686 -8.43892 -1349 4 12.6119 20.404 18.6017 -2.05058 -6.51038 26.2392 -1350 6 53.8702 6.35891 18.9198 29.7306 -6.18586 8.10346 -1351 4 53.0457 6.06715 19.2818 -21.258 -2.7468 0.110915 -1352 4 54.4788 6.08079 19.6257 -1.29631 10.1734 -11.3531 -1353 6 1.76233 4.00968 13.2412 15.2049 -20.178 -6.82767 -1354 4 1.1126 4.5015 13.7221 -14.7745 7.27862 5.55391 -1355 4 1.46634 3.0803 13.3195 6.22895 8.64986 -3.00031 -1356 6 2.68809 16.4658 4.58471 15.0105 -8.44828 17.4213 -1357 4 3.47968 16.3912 5.17607 -18.0483 5.65918 -16.5792 -1358 4 2.952 17.0668 3.88721 1.61121 4.43717 -9.18758 -1359 6 22.6412 7.38905 35.0491 -42.342 -19.7774 -51.2585 -1360 4 21.8701 7.10292 34.411 47.7649 22.3984 34.2121 -1361 4 22.4927 6.7758 35.7601 0.300803 -9.30322 17.5195 -1362 6 30.6449 27.8966 19.9 11.2186 24.5725 -17.4668 -1363 4 31.067 28.6028 19.3405 -15.311 -24.4133 12.7333 -1364 4 30.0502 27.364 19.3383 6.18265 4.0422 4.40167 -1365 6 18.3584 9.54031 6.21119 11.0026 -3.68808 23.2716 -1366 4 18.3645 9.12256 5.3612 -2.33489 -5.22153 -19.3682 -1367 4 19.1216 9.13552 6.66909 -8.40358 6.03455 -2.63927 -1368 6 21.0207 30.3946 30.8361 -20.2261 -14.3153 8.76877 -1369 4 21.7305 31.0371 30.8947 0.539155 4.23503 10.2216 -1370 4 20.6128 30.1908 31.727 18.9681 11.2591 -24.4987 -1371 6 28.3223 4.36971 15.0862 0.785553 22.566 1.53388 -1372 4 27.9162 3.53142 15.2341 -13.4814 -22.4749 6.99245 -1373 4 29.0547 4.16931 14.5133 14.7433 -0.183871 -4.75122 -1374 6 12.7699 0.652736 16.5284 -10.9622 36.0111 -3.70833 -1375 4 13.1417 1.43405 17.0195 -7.22472 -23.339 -11.6266 -1376 4 12.1312 1.03058 15.8629 17.1298 -5.78525 17.4901 -1377 6 27.5613 35.204 8.24204 -17.5468 -3.17574 2.50179 -1378 4 28.0037 35.3359 7.41158 3.58667 2.22765 -10.9792 -1379 4 26.8513 34.5538 8.04841 12.0719 12.2779 8.55847 -1380 6 24.0727 5.16129 41.0114 25.3265 34.0312 4.62534 -1381 4 24.5764 6.00631 41.0278 8.83913 -22.6202 16.662 -1382 4 23.4512 5.41721 40.3589 -27.9927 -11.5371 -21.4854 -1383 6 16.8577 24.9409 28.3044 -13.362 20.9446 -8.34262 -1384 4 15.8529 24.9248 28.4711 42.0709 9.51562 -15.4474 -1385 4 17.0929 25.6637 27.6385 -20.1406 -20.6283 22.1367 -1386 6 20.8367 12.7872 17.016 48.1357 -13.7972 -0.957512 -1387 4 20.9831 13.7012 17.3244 -4.24853 -6.44611 -2.53838 -1388 4 21.7731 12.3998 16.8344 -46.2893 13.5674 8.59046 -1389 6 35.7698 23.0286 30.9167 1.31549 -8.15919 10.0357 -1390 4 34.8007 23.0783 30.9694 4.38358 -0.634017 0.107585 -1391 4 36.0504 22.6611 31.7855 -2.79806 7.45108 -14.1947 -1392 6 36.3049 21.4 25.8723 16.8231 15.2703 -10.059 -1393 4 35.3849 21.2313 25.7163 -23.5769 -6.11261 -4.10927 -1394 4 36.6855 20.6326 26.2849 5.24534 -13.4215 6.45433 -1395 6 13.4896 6.74946 5.28081 -28.3592 57.2786 25.4238 -1396 4 13.8414 6.02988 4.86679 44.4058 -71.9847 -33.7479 -1397 4 12.7199 6.9047 4.75258 -19.8414 9.95147 -1.72496 -1398 6 20.8046 20.4221 13.7595 5.24729 11.8597 -23.4966 -1399 4 21.3314 20.3763 14.5586 1.04488 -1.4591 8.76088 -1400 4 19.8874 20.2651 13.9627 -8.54986 -4.70556 7.47732 -1401 6 20.3763 29.1306 1.39291 -22.654 9.61717 24.1604 -1402 4 20.4714 29.8874 2.01179 2.99602 -8.49852 -9.62387 -1403 4 19.4639 28.7985 1.61052 22.0838 3.18086 -13.1329 -1404 6 50.878 13.1268 37.2744 -6.92527 18.9089 19.2141 -1405 4 51.431 12.5903 37.8743 -5.40112 9.96959 -2.47836 -1406 4 50.5327 13.8902 37.8162 10.8793 -23.2499 -13.6212 -1407 6 33.933 34.1706 20.4988 -24.935 23.2996 -4.02345 -1408 4 33.9537 34.3969 19.5503 3.97405 -5.2202 10.173 -1409 4 33.1424 34.6907 20.8306 20.6842 -17.0796 -4.50693 -1410 6 26.2139 28.0427 27.5441 -18.3219 -6.87449 2.92541 -1411 4 26.6233 28.4264 28.3298 2.52406 0.509022 -5.28732 -1412 4 25.2474 28.0355 27.7473 15.6982 -2.70826 -9.65401 -1413 6 7.68199 21.3044 4.2899 -23.4352 7.97399 30.3744 -1414 4 8.39223 20.9571 3.80392 40.3202 -21.1106 -20.5498 -1415 4 7.23721 21.8696 3.67656 -12.7303 12.1883 -10.427 -1416 6 21.997 15.1678 5.91921 0.156106 10.1967 -8.47357 -1417 4 22.4631 15.3078 5.09012 1.49736 10.8302 -2.43488 -1418 4 21.9323 14.2285 5.99467 -4.63281 -19.7734 10.7123 -1419 6 21.7161 24.0028 3.81129 14.7157 -6.77156 -2.79544 -1420 4 22.6514 24.278 3.99089 -16.266 -7.57571 -5.80044 -1421 4 21.7278 23.1773 3.27349 4.3704 10.7286 8.25651 -1422 6 11.5654 23.7677 12.5675 4.34126 23.9889 5.0328 -1423 4 11.8179 24.711 12.3772 -5.51197 -27.812 -0.203907 -1424 4 11.194 23.7871 13.4529 -2.51135 -1.17837 2.27349 -1425 6 32.365 18.0609 29.8133 5.42876 1.07285 10.0727 -1426 4 33.2855 17.8495 29.9872 2.18588 2.92383 8.75228 -1427 4 32.2516 17.686 28.9464 -9.45666 -7.03173 -17.6671 -1428 6 9.26057 12.3901 30.3108 6.69251 -5.93803 -6.45383 -1429 4 8.9331 13.0089 30.9751 -1.99931 -0.452864 0.983921 -1430 4 10.127 12.0766 30.6488 -15.6011 7.03664 -5.16285 -1431 6 40.1575 25.9297 9.14135 -21.3024 -7.39617 3.31146 -1432 4 40.7828 25.2448 9.36979 6.64832 -8.60816 0.262948 -1433 4 40.6901 26.6937 8.96671 10.3695 18.4246 -3.8085 -1434 6 43.1786 32.337 37.3292 -33.551 -18.2832 -9.28851 -1435 4 42.7165 32.8749 36.6701 14.8891 8.67062 4.46068 -1436 4 42.4294 31.7351 37.5575 24.0939 3.67107 5.33039 -1437 6 44.0961 6.28371 31.2632 9.51948 -8.69332 -33.5784 -1438 4 43.4914 6.92213 31.6058 -15.4833 19.2503 12.9198 -1439 4 44.559 5.89005 31.9835 8.76633 -8.79917 23.1113 -1440 6 10.2083 18.8859 19.6919 15.5822 -2.80816 -8.35433 -1441 4 10.2079 18.3466 20.4907 -1.18434 0.124911 0.125127 -1442 4 9.35433 19.315 19.665 -12.7717 3.54701 3.24565 -1443 6 7.05259 15.5816 15.0277 -11.6868 16.7681 -20.4125 -1444 4 7.21112 15.523 14.0697 -0.749561 -1.2692 3.08306 -1445 4 7.39122 14.7797 15.3874 7.84577 -24.8334 9.86289 -1446 6 24.5366 3.48359 27.8583 16.7503 5.69766 5.18976 -1447 4 23.7024 3.43271 28.3539 -4.73503 -2.50774 -10.2909 -1448 4 24.4259 3.10654 26.9763 -12.6917 -5.22111 2.5626 -1449 6 54.3931 31.8073 9.72289 -3.19054 17.1237 19.0803 -1450 4 53.9641 31.62 8.89214 -6.37727 -2.00813 -13.4715 -1451 4 54.1243 32.7301 9.92854 3.65429 -15.124 -2.64791 -1452 6 6.79493 17.0949 36.2025 -8.81624 7.47492 14.5397 -1453 4 5.9165 16.6466 36.2092 18.1356 5.91394 -12.2869 -1454 4 7.21103 17.1598 35.3293 -13.3551 -7.88765 -1.67162 -1455 6 28.633 7.46221 20.4165 -21.0133 14.9556 -29.8407 -1456 4 27.7506 7.6389 20.7846 4.83271 -6.12746 3.71795 -1457 4 28.5316 7.77661 19.4783 9.56717 -7.40103 22.9991 -1458 6 17.0376 1.7027 8.35788 5.34968 28.5352 32.0038 -1459 4 17.0661 0.753124 8.28199 -2.4228 -14.8367 -20.8379 -1460 4 16.762 2.22772 7.59129 -1.56258 -15.3605 -8.12812 -1461 6 19.1384 19.3343 35.5751 19.5023 3.30605 7.15282 -1462 4 18.4451 18.7061 35.4179 -10.2251 -8.92118 -4.92207 -1463 4 19.8852 18.808 35.914 -3.54436 4.66685 -0.605832 -1464 6 7.31639 31.3666 13.5695 -43.9944 -20.214 -21.2721 -1465 4 6.78612 30.574 13.8569 21.4883 17.7075 -0.698983 -1466 4 6.68503 31.7843 12.9295 22.0056 -0.349161 9.64417 -1467 6 16.674 5.24419 12.8556 -11.0373 -33.5815 5.02698 -1468 4 17.465 5.75961 12.9546 20.2971 3.5869 6.63236 -1469 4 16.7677 4.34295 13.2785 1.53127 21.9447 -10.2143 -1470 6 43.8803 12.7494 34.5747 -22.4085 -20.9808 -0.0671255 -1471 4 43.9515 13.6536 34.2548 -4.30422 8.76569 -3.51904 -1472 4 42.9542 12.429 34.42 18.6754 8.57765 -0.433924 -1473 6 42.6607 36.4569 28.5239 -16.8168 -12.4187 2.20896 -1474 4 42.172 37.2929 28.6321 13.9601 -3.78206 -4.91178 -1475 4 43.5913 36.5775 28.2923 4.62592 13.2896 -0.105187 -1476 6 35.3772 15.0586 6.04009 27.912 48.9275 -7.18458 -1477 4 35.887 15.8982 5.7897 -19.1126 -32.2788 12.1212 -1478 4 34.8045 14.9281 5.27735 -5.52923 -7.04807 -1.55591 -1479 6 19.4078 5.85855 6.1829 -40.2001 -18.9085 -3.31614 -1480 4 18.5441 5.99364 6.63156 8.43156 -9.10613 -8.3884 -1481 4 19.928 6.53616 6.54489 31.8426 31.4232 15.0663 -1482 6 29.261 38.1682 6.98131 -37.2303 32.1811 -6.57247 -1483 4 28.4837 38.0966 7.57517 15.5489 -1.40449 -6.41795 -1484 4 29.8842 37.5088 7.21603 19.671 -25.1607 10.5683 -1485 6 19.357 26.1782 8.47801 4.74765 -18.9961 17.9486 -1486 4 19.3733 25.7814 9.38274 -2.97831 10.6699 -17.265 -1487 4 20.1618 25.7953 8.09114 -4.76457 3.34604 0.730176 -1488 6 4.92328 16.6713 6.1398 7.47336 5.27851 2.26954 -1489 4 5.50113 17.3858 5.8203 -2.76896 -2.40075 1.51866 -1490 4 5.42288 15.8417 6.02573 -4.96937 12.5626 -0.560722 -1491 6 6.06184 16.6875 28.0703 25.9558 6.64688 1.10321 -1492 4 5.15824 16.4097 27.9597 -16.212 -5.66481 -14.185 -1493 4 6.48748 16.8231 27.1848 -21.9791 -6.00697 19.2504 -1494 6 21.7362 29.3702 22.1089 -17.2737 20.913 34.8846 -1495 4 21.4452 30.3289 22.1112 6.19611 -27.0689 0.469942 -1496 4 21.3293 28.9728 22.9428 14.5469 12.9694 -26.9427 -1497 6 24.4985 0.540505 12.8515 12.2489 -9.36427 2.95715 -1498 4 24.0437 0.939092 12.114 -3.50986 5.42614 -10.4761 -1499 4 24.1106 0.99496 13.5957 -0.561841 3.41965 12.163 -1500 6 18.4019 28.2584 40.3145 -11.401 19.5033 -15.6681 -1501 4 18.3886 27.6361 41.0165 -1.05122 -20.6036 22.2694 -1502 4 19.1831 28.024 39.826 8.23901 2.08545 -8.43276 -1503 6 10.3826 17.4565 21.9113 1.92941 -13.2413 3.45357 -1504 4 9.8824 16.6205 21.8349 3.82121 7.52813 2.02092 -1505 4 9.93899 17.9725 22.5913 -5.82795 2.16988 4.16556 -1506 6 13.5489 13.3588 39.6353 11.9209 29.8927 39.0415 -1507 4 13.8427 14.2544 39.3649 -8.64321 -16.3346 -3.85104 -1508 4 13.5548 13.4385 40.6332 -1.97454 -11.1079 -31.9482 -1509 6 19.5449 26.0093 24.7389 -52.2633 13.2593 -7.73686 -1510 4 19.57 25.3975 24.0097 10.2262 -10.7296 -10.4349 -1511 4 20.3304 26.0184 25.2393 35.6126 -10.3894 17.1361 -1512 6 8.93096 25.8929 20.0882 -7.71251 -64.4566 3.30388 -1513 4 8.30787 26.3938 20.5887 -11.4685 32.8171 11.63 -1514 4 9.62246 26.3511 19.648 20.7791 34.2926 -13.3665 -1515 6 13.4555 41.2072 30.5108 -10.8988 -15.928 5.69795 -1516 4 14.2767 41.1294 31.0436 -12.4449 -5.39064 -3.38157 -1517 4 12.7718 40.5451 30.8276 25.6688 18.9533 -5.69319 -1518 6 21.165 21.6707 11.1126 6.53241 11.8742 3.94385 -1519 4 20.8889 20.8699 10.6872 -6.5221 -17.8932 -11.6656 -1520 4 21.171 21.4318 12.0451 -0.673303 -0.892159 6.0991 -1521 6 43.5659 10.3222 15.565 -2.18625 -17.2881 -4.53442 -1522 4 43.269 9.50121 15.139 10.696 3.36153 7.59808 -1523 4 42.8911 10.937 15.2983 -10.0921 17.3133 -0.93945 -1524 6 23.5255 5.06673 12.3063 -8.27451 55.1521 -7.02327 -1525 4 23.4703 4.15364 12.096 -5.93718 -33.8878 -14.7403 -1526 4 23.077 5.57318 11.5535 15.1023 -26.9196 22.8331 -1527 6 9.29314 15.4001 4.25145 -3.86255 -4.02248 -25.5662 -1528 4 8.9509 16.1187 4.78154 1.1615 8.22379 13.6068 -1529 4 9.97933 14.9549 4.74249 8.84801 0.0887981 11.7331 -1530 6 26.7067 10.8779 17.5788 3.55047 -19.7627 -22.9275 -1531 4 26.5537 10.995 18.4988 -3.13636 8.79354 30.8805 -1532 4 26.79 11.729 17.1566 -1.16375 6.51516 1.16674 -1533 6 26.0497 23.6027 33.6801 19.5894 25.2732 20.1931 -1534 4 25.4452 23.9936 33.0304 1.52608 5.68176 -1.06817 -1535 4 26.6384 24.3139 34.1277 -30.0139 -24.8801 -23.6693 -1536 6 7.5709 10.5028 28.9083 -0.962228 -19.583 -21.6711 -1537 4 6.74329 10.4799 29.4005 3.80738 8.46019 8.36633 -1538 4 8.19878 11.0832 29.3397 0.629116 8.24646 12.7121 -1539 6 16.498 16.9072 24.6485 7.82025 23.6222 16.3151 -1540 4 16.0345 17.7596 24.5588 5.31695 -3.73313 -0.390286 -1541 4 16.1792 16.4208 23.9083 -7.11448 -16.9587 -21.9433 -1542 6 12.549 12.7866 0.448591 8.35618 6.39845 34.9671 -1543 4 12.9768 12.9146 1.38779 -15.5602 -17.6496 -50.0052 -1544 4 12.7689 11.9205 0.0349689 0.659473 7.36742 13.3893 -1545 6 6.80731 2.45617 9.05869 -7.23501 -7.03372 -0.578084 -1546 4 7.10343 3.02287 9.78944 7.77528 -6.31722 -2.26682 -1547 4 7.3272 1.63733 8.99034 2.01029 5.74015 6.94656 -1548 6 28.8877 11.8706 12.0154 41.6386 34.6329 -2.99516 -1549 4 28.2108 12.4771 11.6895 -6.34049 1.49886 1.56166 -1550 4 29.7533 12.3393 11.8008 -29.7579 -18.4108 8.17464 -1551 6 44.6745 32.5962 29.7139 -34.2161 4.66467 6.73964 -1552 4 43.7628 32.9784 29.4642 35.9402 -16.1761 10.2258 -1553 4 44.5125 31.9002 30.3967 -1.3182 18.2082 -15.8911 -1554 6 28.5995 15.1068 32.2872 13.2766 -51.3111 -20.1848 -1555 4 29.0279 15.8582 31.8991 2.31019 19.0875 -3.40369 -1556 4 29.0943 14.3419 31.8537 -21.7517 23.8731 20.1718 -1557 6 1.14062 22.1898 33.6289 -39.3586 14.574 19.5436 -1558 4 0.65227 22.798 33.0535 3.91391 -2.7929 6.08546 -1559 4 1.82717 21.8879 33.088 34.4042 -16.5957 -27.8984 -1560 6 17.4513 16.8201 9.93098 -1.82085 -23.3459 26.2514 -1561 4 17.8906 17.1746 9.18159 7.86355 15.3521 -22.135 -1562 4 18.0267 16.0779 10.2085 -7.73246 7.19916 -1.96586 -1563 6 18.7435 29.8048 14.4095 21.7061 -3.72347 40.0221 -1564 4 19.5652 29.5706 14.9087 -19.4331 3.67999 -8.42588 -1565 4 18.9661 29.6909 13.4944 1.97037 -1.23698 -19.2163 -1566 6 39.4071 6.51101 13.0179 12.0574 6.81682 -11.0022 -1567 4 39.7785 7.30288 12.5709 -10.193 -11.7897 7.6563 -1568 4 39.9532 5.78104 12.6849 -4.03584 4.98089 5.48617 -1569 6 54.0977 38.2821 14.3159 8.76467 -13.509 23.2458 -1570 4 53.5116 38.6447 15.0061 0.0542658 1.01747 -18.4972 -1571 4 53.8554 38.6311 13.4594 -12.9742 11.219 -5.93773 -1572 6 7.52036 32.013 20.9427 34.362 14.2167 21.5407 -1573 4 7.05735 31.9924 20.1252 -18.8869 -6.37038 -21.2822 -1574 4 7.04171 31.4816 21.5607 -16.1882 -11.3569 11.099 -1575 6 26.965 15.5039 13.8257 -10.8147 -22.3452 14.7237 -1576 4 27.2177 14.7358 14.3683 8.65177 6.42067 -5.59001 -1577 4 26.0429 15.6169 14.0906 -6.80859 9.66341 -6.51148 -1578 6 18.3782 16.4473 32.1249 -4.95226 -1.86998 -9.87987 -1579 4 18.1426 16.6374 31.1969 4.73263 -0.719504 8.39792 -1580 4 19.0836 17.0573 32.3614 6.73072 6.57595 -2.73442 -1581 6 52.4873 31.678 23.2415 -44.1119 -6.58328 47.4356 -1582 4 52.4708 32.2686 24.0415 7.23299 -8.75358 -21.8316 -1583 4 53.1739 31.883 22.645 31.3465 14.6123 -23.9869 -1584 6 2.16824 9.71317 28.2162 5.46837 -18.1801 7.45826 -1585 4 2.48183 10.5213 27.7929 -7.61484 8.72751 3.65687 -1586 4 1.37959 9.87032 28.768 3.44281 10.2362 -4.06622 -1587 6 32.9194 0.0905733 22.5781 10.5432 -20.5017 -7.42813 -1588 4 33.2395 41.1185 22.3208 -17.3926 6.61176 1.08087 -1589 4 33.7441 0.505918 22.8191 5.29332 16.1982 3.6992 -1590 6 20.7309 41.5697 38.6372 28.3147 -14.9122 -44.687 -1591 4 20.0328 41.0591 39.0281 -13.7779 -1.58578 11.2509 -1592 4 21.0348 40.9602 37.8857 -7.98591 29.4899 32.1121 -1593 6 43.3035 24.332 12.1458 11.7575 -1.61212 -4.71191 -1594 4 43.2118 25.2792 12.3722 8.64503 -11.1136 -9.01316 -1595 4 44.1249 24.1975 11.6011 -17.6772 13.9566 14.4164 -1596 6 22.028 36.2965 11.8178 -12.5217 11.0116 -6.64335 -1597 4 21.6755 36.9888 11.229 7.35556 -7.61462 10.605 -1598 4 22.8593 36.0261 11.4203 4.02803 -2.23458 -0.408194 -1599 6 50.7458 20.5312 30.3336 -27.3371 19.0798 0.575242 -1600 4 50.2829 20.0188 31.024 4.3389 0.549123 -5.17754 -1601 4 50.1148 21.2814 30.1453 20.3707 -20.1638 4.65154 -1602 6 20.8352 3.85006 18.1924 -4.58005 6.82859 16.651 -1603 4 21.6331 4.17131 17.7775 4.55578 1.29171 -4.07778 -1604 4 20.7516 4.34878 19.0287 -0.852135 -6.30171 -7.97465 -1605 6 4.00732 20.6422 6.98905 -51.5603 -31.2986 19.6291 -1606 4 3.1116 20.4695 6.56725 35.2765 12.481 -1.34365 -1607 4 3.83148 20.2497 7.8921 17.5771 16.9916 -21.2359 -1608 6 11.9503 15.4361 41.4392 2.8915 -19.3712 8.63656 -1609 4 11.9967 14.4718 41.7234 3.98465 29.7679 -14.4511 -1610 4 12.4631 15.5787 40.6176 -3.08486 -9.43894 7.49139 -1611 6 3.00006 18.5443 38.9307 7.29951 -23.84 25.6029 -1612 4 3.57591 17.7463 38.8471 -9.50595 12.5214 2.28144 -1613 4 2.93408 18.9335 38.0756 -3.85177 13.2219 -26.1975 -1614 6 8.60604 38.8696 11.3027 41.4164 30.2615 0.48057 -1615 4 9.41419 39.0226 10.7506 -16.8144 -5.25469 8.62565 -1616 4 8.21901 38.0768 10.9944 -17.9318 -38.1368 -15.4555 -1617 6 12.9777 33.9736 38.4849 13.2116 9.7409 3.49313 -1618 4 12.6169 33.1824 38.0476 12.8065 1.18326 0.516457 -1619 4 13.9558 34.0654 38.367 -20.6967 -9.66923 -0.235313 -1620 6 4.68265 11.9882 6.05233 -5.36104 -17.6375 -21.4001 -1621 4 3.82121 11.6194 5.80881 -7.3972 4.97776 10.103 -1622 4 5.22981 11.6659 5.30604 -0.806592 6.4598 12.5779 -1623 6 10.8388 15.9226 25.2234 -25.8257 0.885817 -3.68505 -1624 4 11.7194 16.2357 25.361 23.5714 9.8582 3.12124 -1625 4 10.3656 16.637 24.773 5.49819 -5.38784 0.449897 -1626 6 20.7519 3.25216 6.54608 14.2232 16.6176 4.63006 -1627 4 20.286 2.47445 6.25961 -10.3965 -11.4853 -2.16446 -1628 4 20.1859 4.03183 6.47283 -6.25253 -2.40724 -3.99784 -1629 6 47.6296 39.155 31.2075 -6.94169 16.2372 -29.2685 -1630 4 46.6717 39.1522 30.9686 19.778 5.05469 4.61154 -1631 4 48.0746 39.7923 30.5789 -18.3255 -25.0069 20.1215 -1632 6 8.32942 27.7692 27.6861 -22.9675 10.5768 13.2964 -1633 4 7.92083 27.0814 28.2574 8.55111 11.2092 -8.24047 -1634 4 9.05389 27.3382 27.2479 10.5137 -11.4359 -5.41666 -1635 6 33.26 40.3166 33.4176 17.9089 -0.14465 -4.13778 -1636 4 32.5337 40.9457 33.2593 10.2249 -4.59604 -5.86803 -1637 4 34.0027 40.4737 32.781 -17.2015 3.54767 8.86095 -1638 6 24.5063 34.6298 27.2698 0.491312 8.45089 -9.78892 -1639 4 24.8706 35.531 27.0561 -9.74802 -22.5685 0.190878 -1640 4 24.1 34.2837 26.4337 10.8101 11.1551 19.1745 -1641 6 13.3248 36.7606 35.7302 31.7841 1.54421 8.12469 -1642 4 14.2215 36.6075 36.119 -13.0291 10.9369 -8.07597 -1643 4 12.8242 36.0333 36.0767 -19.6956 -11.898 1.78685 -1644 6 34.0654 20.1519 33.2169 18.328 45.6356 -7.38724 -1645 4 34.7846 20.5927 32.7056 -13.2567 -20.8909 7.62801 -1646 4 33.6055 20.9496 33.5712 -4.62613 -21.3045 2.82084 -1647 6 22.8301 33.56 31.6141 4.86266 11.3389 -12.2002 -1648 4 23.5774 34.1707 31.5466 -2.83601 4.36281 -5.03091 -1649 4 23.1188 32.9172 32.2538 0.234413 -13.6868 11.6365 -1650 6 23.7437 2.42751 19.8437 5.37542 22.288 12.015 -1651 4 24.549 1.92657 19.7151 11.8542 -9.34304 -3.08207 -1652 4 23.0522 1.96699 19.3939 -17.1839 -15.7883 -12.7178 -1653 6 10.5922 1.64055 20.5239 -11.6119 -4.18685 -4.47424 -1654 4 10.0475 0.976152 20.0603 6.63037 0.339841 6.84259 -1655 4 10.5 2.45781 20.009 1.22375 1.55874 1.33627 -1656 6 6.49834 24.8637 7.80908 13.1619 -16.462 -27.2261 -1657 4 7.39752 24.8711 7.42138 -7.39511 8.18905 12.026 -1658 4 6.07255 24.1767 7.26903 -7.5733 6.7583 6.8074 -1659 6 54.7892 32.5297 25.4757 -1.36407 18.5665 -18.8778 -1660 4 54.0312 33.1434 25.3693 10.0694 -13.7478 6.1371 -1661 4 0.333918 32.6202 24.6425 -12.8409 -6.42816 22.883 -1662 6 6.2467 20.1884 28.9797 -14.5872 3.94595 -2.55046 -1663 4 5.42154 20.1642 28.4577 8.07739 1.90281 8.6477 -1664 4 6.84484 19.6236 28.4838 10.3646 -4.74821 0.341067 -1665 6 50.0565 21.6117 11.3373 -2.04109 28.5423 -29.4123 -1666 4 50.95 21.7264 10.9878 2.40449 3.31798 -5.14809 -1667 4 50.1463 20.9073 11.9368 0.900865 -33.3483 27.1981 -1668 6 43.4794 33.5181 19.6392 10.2306 -3.22473 -8.26676 -1669 4 43.7308 33.5714 20.5426 20.9097 -0.172793 18.6354 -1670 4 42.5556 33.6283 19.7345 -31.1875 3.87355 -8.92325 -1671 6 30.8203 7.18413 41.0653 -47.5647 29.7584 13.5959 -1672 4 29.9879 7.63165 40.681 33.629 -21.8567 10.9994 -1673 4 30.7637 7.50249 0.10761 7.36747 -14.0232 -31.1296 -1674 6 12.1328 25.8622 11.0863 -33.3162 -17.1307 -4.35232 -1675 4 11.2035 26.0164 10.7385 31.652 5.74526 10.6132 -1676 4 12.7063 26.6022 10.9281 7.22016 21.1466 -6.88425 -1677 6 47.8272 5.81934 17.7377 34.4122 -10.5063 -19.6374 -1678 4 48.0885 5.28838 16.9377 -7.84164 17.03 17.5567 -1679 4 48.6906 6.1712 18.0872 -20.5621 -5.0871 -4.09565 -1680 6 35.1646 12.9005 16.5891 -8.94037 2.15609 -8.82704 -1681 4 35.428 13.0005 17.5199 -6.39768 8.78744 -5.13392 -1682 4 34.5308 13.6301 16.3523 17.2323 -15.7422 12.9621 -1683 6 10.4611 10.6156 33.9687 -31.8989 -9.58391 14.7288 -1684 4 10.7981 11.3375 34.5166 5.24051 -2.75865 -7.26377 -1685 4 9.62118 10.4004 34.4306 17.5569 -1.50819 -12.473 -1686 6 9.86916 7.4616 9.67483 -1.17411 0.415312 -19.5192 -1687 4 9.17172 8.12646 9.7346 0.921409 2.8109 10.1471 -1688 4 9.97058 7.3459 8.70248 1.1017 -0.154201 19.4763 -1689 6 11.1489 9.5612 29.1408 -3.50418 -13.4139 2.93109 -1690 4 10.6848 9.26325 29.9428 4.68224 5.10434 -5.79998 -1691 4 11.3989 8.73954 28.6776 0.998479 5.88331 1.3781 -1692 6 46.4028 12.7539 37.8993 8.34964 0.221 -8.93676 -1693 4 46.6625 12.9969 36.9769 -3.46511 -1.57209 17.4302 -1694 4 46.8246 13.3669 38.5286 -1.63466 -3.53539 -5.22058 -1695 6 4.76485 19.028 16.0085 -13.5875 12.8334 -9.71245 -1696 4 4.2246 19.0797 16.8211 14.4547 -7.44532 -2.23877 -1697 4 5.5965 18.5831 16.2078 1.83868 -2.3176 10.3072 -1698 6 50.2593 39.8135 19.3633 -11.209 7.32279 -16.1387 -1699 4 50.2357 39.0929 20.0186 -9.83071 -0.813057 -10.1916 -1700 4 49.5811 39.7404 18.6324 20.3589 -6.83946 23.6454 -1701 6 3.57863 23.2976 26.309 -19.8478 3.89203 -2.42552 -1702 4 2.95325 23.1663 25.5593 11.1236 -1.69658 12.5574 -1703 4 3.09228 23.9147 26.9028 8.7219 -10.8877 -9.85517 -1704 6 43.325 18.2347 20.509 -6.81505 -1.42332 -3.46621 -1705 4 42.8171 19.0284 20.7204 1.20306 1.51529 1.23812 -1706 4 43.8577 18.0426 21.2915 2.12676 -2.58083 4.4502 -1707 6 14.5031 41.5275 19.7277 -3.40329 -5.13047 -40.8094 -1708 4 13.9246 41.7804 20.437 0.184992 5.83632 25.1113 -1709 4 15.42 41.4218 19.9774 10.3149 -1.62678 14.571 -1710 6 29.2836 29.8681 26.9083 14.7251 3.00272 -32.0725 -1711 4 29.2754 29.741 25.8744 6.18055 14.2787 56.2455 -1712 4 30.1283 30.2623 27.2985 -22.384 -15.5718 -22.4063 -1713 6 6.3217 26.153 11.5726 -10.9318 2.11689 -6.65038 -1714 4 6.21736 25.7454 12.4421 7.16784 6.77942 9.71283 -1715 4 6.96084 26.8819 11.5675 -0.124344 -5.20772 8.78036 -1716 6 27.6636 9.22988 15.2432 27.2347 15.0341 -6.49447 -1717 4 28.4103 9.83484 14.9873 -20.1055 -14.3916 8.85848 -1718 4 27.7674 8.48088 14.6445 -1.45999 -3.40178 1.02673 -1719 6 29.7804 38.0662 17.0819 -1.94795 -3.59677 -9.66723 -1720 4 29.6031 37.2203 16.6025 -2.55573 18.1678 4.54076 -1721 4 29.1155 38.7497 16.8561 3.55432 -16.3657 1.57327 -1722 6 52.2257 28.7184 4.26028 43.5541 11.735 -13.9492 -1723 4 53.1498 28.7813 3.86382 -28.9168 1.3453 15.0129 -1724 4 51.9642 27.8111 4.13511 -4.98861 -18.1961 -3.0857 -1725 6 17.1716 16.6708 6.09349 0.800403 22.8617 11.3476 -1726 4 16.9906 17.4665 6.64994 5.32834 -8.85643 -15.9231 -1727 4 16.9912 15.9587 6.69883 -0.0606397 -19.1034 5.18453 -1728 6 36.6551 7.54529 33.4256 0.520164 -21.8515 26.6937 -1729 4 35.9994 7.02185 33.9501 8.71508 10.7979 -12.9224 -1730 4 36.139 7.85703 32.6949 -12.9525 8.58568 -17.7829 -1731 6 26.1712 3.13186 9.59195 18.1066 21.2961 -28.5304 -1732 4 26.5502 3.5196 10.357 16.0028 12.4994 23.003 -1733 4 25.6506 2.45477 9.93435 -32.3265 -38.1289 14.2303 -1734 6 1.19956 17.1196 33.1708 -2.2935 18.3305 -9.07621 -1735 4 1.01553 17.8006 32.4822 1.56489 -10.8534 12.1427 -1736 4 0.844206 17.4429 34.0214 2.04572 -1.59411 -6.06332 -1737 6 29.1739 10.178 5.37516 -2.40587 -18.3881 11.7134 -1738 4 28.5386 10.354 6.08377 0.376669 4.93981 -3.98875 -1739 4 29.4881 9.26834 5.54278 -5.29161 7.67482 -7.40705 -1740 6 9.22817 21.1342 0.188585 30.2393 3.90367 9.01386 -1741 4 10.0008 20.6689 41.6954 -19.6386 2.89796 1.05729 -1742 4 8.40981 20.8027 41.7407 -2.68979 -7.66638 -7.21336 -1743 6 7.42006 26.8879 34.8536 3.14545 16.5486 30.4349 -1744 4 7.04622 27.0927 35.7464 10.1233 -6.04195 -26.4158 -1745 4 6.87255 26.19 34.5186 -13.4343 -18.5802 -10.0193 -1746 6 18.6153 10.1647 3.02259 -21.2705 37.3854 6.86975 -1747 4 17.9982 9.42011 2.89287 2.11135 15.8633 3.52195 -1748 4 18.115 11.0437 3.25865 19.508 -44.5053 -11.6159 -1749 6 13.1266 21.2208 25.207 -7.78894 4.80204 -7.88194 -1750 4 12.927 21.6586 24.3646 3.95449 -7.72121 4.87382 -1751 4 12.8054 20.3208 25.1571 -2.69895 -8.80511 -3.48609 -1752 6 4.90585 24.4116 40.531 -24.4864 -14.2944 -35.1794 -1753 4 5.64285 24.6041 41.0938 21.6142 3.21823 7.1591 -1754 4 5.22115 23.997 39.6806 -3.1008 12.4445 27.1665 -1755 6 54.7234 6.29054 9.93868 16.9838 3.76988 -11.4262 -1756 4 54.1595 6.0167 10.6465 -16.0707 -8.53288 16.3243 -1757 4 -0.00708757 7.17696 10.1972 2.88265 8.42125 0.296955 -1758 6 51.7481 16.6603 19.3703 -0.380283 5.87397 -29.4424 -1759 4 51.6376 16.2748 18.4816 -6.94363 -1.60509 11.109 -1760 4 52.3909 17.3585 19.2003 6.35466 6.30558 5.78841 -1761 6 38.6244 2.9738 13.1093 11.8256 2.30897 44.7329 -1762 4 38.5518 3.44318 13.9917 -0.399232 -9.9856 -23.4333 -1763 4 38.2423 3.54447 12.4592 -11.1085 17.5319 -17.0773 -1764 6 19.4422 35.7095 9.59568 3.40577 -0.828385 -4.73593 -1765 4 18.7414 36.105 9.07989 -9.16576 -3.00828 -7.06541 -1766 4 19.0009 35.4265 10.4088 3.97598 4.46758 -4.25365 -1767 6 46.943 37.6271 25.6985 10.3793 1.77648 -5.56802 -1768 4 47.12 37.9785 24.823 -9.34628 8.6078 -10.4475 -1769 4 47.7536 37.1497 25.8683 2.27046 -5.59472 9.98269 -1770 6 20.0359 17.269 14.7493 3.99527 -1.04076 21.685 -1771 4 19.226 17.5112 15.2169 -1.54973 1.23777 -13.9596 -1772 4 20.6203 17.0021 15.471 1.89523 -0.789097 -10.2839 -1773 6 24.7462 29.2867 3.75843 -10.1451 -8.18783 10.4774 -1774 4 24.6712 28.3277 3.51733 13.2212 23.8029 -9.5704 -1775 4 25.3186 29.8222 3.19111 0.258423 -15.3949 -10.1904 -1776 6 3.43 8.91865 6.82525 30.9316 4.78471 42.1024 -1777 4 3.12906 8.84201 7.76799 3.51474 0.65101 -30.0512 -1778 4 4.4001 9.15772 6.93718 -35.8795 -6.21414 -10.2854 -1779 6 17.4867 30.5875 19.7089 25.363 -13.1809 -11.8275 -1780 4 18.4189 30.3609 19.3993 -33.7851 8.31766 10.936 -1781 4 16.9116 29.8624 19.4038 1.038 7.7974 -2.73085 -1782 6 13.2718 16.1862 39.0546 8.76191 -18.4723 6.03369 -1783 4 13.8233 16.8904 39.4031 3.30361 7.54485 1.72389 -1784 4 12.5422 16.5765 38.5789 -11.7633 13.4881 -8.40344 -1785 6 23.832 27.9756 11.5898 -7.03122 5.38421 -2.05105 -1786 4 23.0756 27.4469 11.9259 8.81977 12.3317 -3.01362 -1787 4 23.7182 28.9056 11.8688 -5.28793 -12.9553 -0.41204 -1788 6 14.4579 24.426 21.2343 -3.66896 12.863 -1.79834 -1789 4 13.9584 25.2806 21.2855 7.33453 -15.5065 2.73981 -1790 4 14.2661 23.9117 22.0367 -3.91682 9.90798 -0.991428 -1791 6 46.6073 15.1543 22.2965 -20.8333 -3.77381 -11.8272 -1792 4 45.9584 14.6421 21.811 -6.87655 -3.95362 10.1018 -1793 4 47.2458 15.2644 21.6001 24.1162 10.8017 0.759212 -1794 6 19.1409 29.7195 11.8497 24.0494 -34.2428 10.0272 -1795 4 18.8784 30.5975 11.5793 -19.1418 4.86007 -17.3781 -1796 4 18.6106 28.9994 11.4276 0.263541 23.8948 1.0376 -1797 6 36.9127 18.8084 27.6222 -22.9356 -21.6011 26.171 -1798 4 36.4352 18.471 26.8408 6.36827 4.7914 5.64024 -1799 4 36.536 18.2194 28.3533 14.6987 24.2872 -28.1415 -1800 6 35.8684 17.5378 25.4906 20.6945 -0.513689 -30.4481 -1801 4 36.5966 17.7728 24.866 -15.8574 8.27186 11.6809 -1802 4 35.9779 16.5759 25.48 -10.902 2.42848 10.2606 -1803 6 8.03691 41.9141 31.5248 13.0394 10.4535 -6.8036 -1804 4 8.57921 41.2412 31.9888 -13.1962 14.522 -11.1095 -1805 4 8.63283 0.684743 31.1326 -8.3799 -15.4286 7.32752 -1806 6 31.7059 34.8342 17.9371 1.99631 -25.0047 -8.79133 -1807 4 32.5911 34.4609 17.7211 -13.4776 12.334 6.09844 -1808 4 31.8527 35.7258 18.2497 13.1847 15.6537 3.27409 -1809 6 22.1093 41.055 5.1451 11.5479 29.9587 -53.8497 -1810 4 22.1004 40.5969 5.93279 -2.68624 -33.8843 55.363 -1811 4 22.7885 40.6204 4.60559 -4.38419 0.844423 3.37931 -1812 6 11.6153 5.16618 29.5584 -27.6475 13.1782 12.6346 -1813 4 12.1606 4.37097 29.6057 -8.91967 -2.9702 4.15115 -1814 4 10.7377 5.1092 30.0631 35.581 -10.2726 -16.0904 -1815 6 13.0239 9.45481 21.0754 -25.8377 -26.1508 -25.9824 -1816 4 13.6778 9.97234 21.4999 31.652 16.6928 15.5055 -1817 4 13.4195 8.72209 20.5617 -0.589626 12.3395 6.44381 -1818 6 12.4227 4.1736 0.163828 29.6522 45.8695 -12.8421 -1819 4 12.6651 3.77524 1.00427 0.341759 -1.42745 2.51987 -1820 4 13.0617 4.97102 0.020112 -31.9214 -41.0145 4.8633 -1821 6 45.168 14.6284 28.1023 4.783 -10.4532 13.0266 -1822 4 45.253 14.8969 27.1759 8.39119 -6.85383 -0.732919 -1823 4 45.9575 14.0916 28.3529 -13.3622 13.2892 -14.7888 -1824 6 52.571 19.2551 0.894665 -6.12931 -19.318 2.27414 -1825 4 52.6102 19.199 41.8388 0.592413 0.00811024 1.08479 -1826 4 52.8129 20.1442 1.11528 6.55776 18.4237 2.43046 -1827 6 0.161625 18.5694 30.5785 -3.0227 0.535636 4.36465 -1828 4 0.968981 18.7291 30.0798 6.18464 -7.16445 -2.53371 -1829 4 54.7907 19.4514 30.677 -10.8229 5.89199 6.00525 -1830 6 17.6528 28.1849 1.96402 -7.28907 9.7522 11.2687 -1831 4 16.9769 28.8628 1.74785 9.23997 -9.27082 -2.31394 -1832 4 17.6006 28.1534 2.93661 3.56557 1.38454 -8.44201 -1833 6 22.5099 30.1653 5.01109 -1.02808 20.8676 -0.473944 -1834 4 23.1753 30.1014 4.30975 -2.49536 -9.56192 4.09657 -1835 4 22.058 29.3206 5.04766 -1.45363 -6.71999 -4.50103 -1836 6 11.4023 8.80853 17.6459 -26.9993 9.53928 -4.75555 -1837 4 11.8645 8.1762 18.2108 15.3222 4.18532 1.52515 -1838 4 11.9865 9.48216 17.2519 4.47877 -12.4161 10.2871 -1839 6 32.2917 3.59674 26.8117 35.3382 32.7507 -4.14644 -1840 4 31.8458 3.34967 26.0065 -10.4154 -4.5889 -14.8452 -1841 4 32.8806 4.37505 26.5671 -21.1848 -26.3524 0.379863 -1842 6 26.835 37.1568 15.6529 -0.874066 14.8773 29.2405 -1843 4 26.7488 37.4766 16.567 0.376185 8.65421 -15.6923 -1844 4 26.6891 36.2303 15.7909 -0.851881 -23.4278 -14.9094 -1845 6 22.9473 3.40289 22.286 14.7574 -3.5158 -4.23343 -1846 4 23.2792 2.98888 21.4515 -4.53852 7.92848 16.4552 -1847 4 23.7307 3.68139 22.8048 -11.9145 -5.32443 -10.4265 -1848 6 14.6269 28.2214 5.19572 6.06687 6.51489 2.87291 -1849 4 14.1454 28.1555 4.36712 -3.39073 -3.27129 -8.45242 -1850 4 14.2747 28.9991 5.64824 0.61258 -1.12864 1.62503 -1851 6 20.2538 37.2031 16.5466 -28.2562 5.81675 18.2866 -1852 4 21.1004 37.4666 16.2032 21.0823 8.59207 -3.85991 -1853 4 20.0754 37.7549 17.3418 4.82626 -5.93036 -10.2325 -1854 6 17.9544 28.5616 23.889 16.4449 -8.57642 -4.83649 -1855 4 18.808 28.1928 23.5683 -20.3084 2.86715 8.85187 -1856 4 17.2559 27.9215 23.6535 6.51898 5.694 -2.26134 -1857 6 33.646 24.2349 25.2286 -4.54069 1.10679 -14.8717 -1858 4 33.6591 23.269 25.0602 3.54988 10.512 10.2941 -1859 4 34.0237 24.3938 26.1034 0.864522 -9.38336 -2.59148 -1860 6 9.98122 17.6138 2.21344 7.43797 -27.5786 -7.49496 -1861 4 10.832 17.5317 1.73219 -10.6429 3.93943 7.97636 -1862 4 9.86311 16.7639 2.69719 0.409905 15.8492 -4.6087 -1863 6 24.3357 36.801 8.92185 2.98992 -6.60779 12.1866 -1864 4 24.0742 37.6409 8.56425 -5.30422 15.3919 -5.44039 -1865 4 24.7315 37 9.77917 -2.43549 -6.6012 -3.30269 -1866 6 14.4004 4.29557 27.7519 47.583 -3.32523 5.14754 -1867 4 15.335 4.40276 27.3948 -30.4143 -4.44284 13.8265 -1868 4 13.81 4.42145 27.0177 -13.2435 3.17509 -11.8406 -1869 6 13.214 25.4576 35.3169 -22.1271 -24.6319 4.29258 -1870 4 13.1587 25.1592 36.2444 11.1778 9.47444 -6.90086 -1871 4 12.4637 24.9943 34.8985 11.1514 12.2923 -1.08233 -1872 6 43.7301 33.1781 24.4042 -1.93578 -20.5981 16.0744 -1873 4 44.3223 32.959 25.1725 -10.0543 8.3706 -19.7015 -1874 4 44.0713 33.9344 23.9169 6.22405 5.02536 3.22562 -1875 6 6.9686 30.4099 7.14637 29.0056 7.39031 21.9321 -1876 4 6.75777 29.9621 7.98042 -5.17066 0.417247 -5.37485 -1877 4 6.23168 30.2842 6.57126 -23.4728 -6.8193 -11.7975 -1878 6 44.4308 39.4237 21.7855 -4.33275 0.914597 7.54549 -1879 4 43.8654 38.932 21.1541 10.179 9.64354 2.62582 -1880 4 45.001 40.0603 21.3196 -6.51882 -12.4268 -7.79327 -1881 6 1.18424 16.4398 24.9903 -32.4903 25.5998 2.59769 -1882 4 0.976951 16.9992 24.2076 17.4753 -17.2203 8.72915 -1883 4 0.385168 16.6115 25.5394 23.4019 -14.126 -4.16352 -1884 6 8.17355 33.8284 10.6836 -2.7688 -6.92624 14.1509 -1885 4 8.34263 33.4451 9.83813 20.7133 -1.8248 -25.0865 -1886 4 7.32622 33.4212 10.8229 -22.0824 -0.650197 20.9959 -1887 6 45.3734 15.866 40.492 8.57481 -12.1553 -4.93844 -1888 4 44.519 15.6937 40.0698 -0.240559 4.546 7.41406 -1889 4 45.2892 16.6061 41.0987 -5.95018 0.957053 0.609678 -1890 6 38.79 4.28815 15.8976 0.37918 -2.10791 -10.8791 -1891 4 39.6838 3.98516 16.099 -1.14178 2.00828 6.51653 -1892 4 38.4576 4.71748 16.7012 5.69678 -4.45181 -3.36891 -1893 6 21.0946 9.20757 23.9781 -15.5567 7.8487 -28.256 -1894 4 20.9171 8.74785 23.1381 12.0597 -4.77706 12.6228 -1895 4 20.522 9.98378 23.8483 8.03519 -2.74416 16.612 -1896 6 6.47513 36.1489 20.0112 1.62078 -0.443995 1.26518 -1897 4 5.91587 35.3892 19.7749 1.1588 6.62155 -0.72477 -1898 4 7.29927 35.7814 20.3561 -3.99682 -1.77997 -1.59627 -1899 6 17.7466 23.4563 11.2529 28.5847 -29.2717 26.027 -1900 4 17.0283 23.9723 10.9251 -27.3158 17.875 -1.49359 -1901 4 17.6201 23.2782 12.2162 -8.22502 9.28058 -23.7318 -1902 6 2.23619 39.2644 23.5388 49.8561 -28.1857 -22.6679 -1903 4 2.97831 38.9599 24.1359 -27.9038 8.524 -11.8523 -1904 4 2.61824 39.0932 22.6246 -22.7997 11.7085 33.9524 -1905 6 21.7216 10.3211 3.08421 -18.2449 14.4951 30.0936 -1906 4 21.8041 10.0076 2.215 15.0715 -18.3252 -42.7176 -1907 4 20.7597 10.3501 3.18369 2.1836 1.89441 6.77029 -1908 6 13.3346 37.6456 26.8309 31.2085 -13.7023 -2.95714 -1909 4 12.8405 36.9633 27.2803 -9.16641 -7.21061 8.74396 -1910 4 14.167 37.1703 26.5501 -23.1686 18.0804 4.61389 -1911 6 45.6739 9.85296 8.82966 10.4005 6.57186 1.33947 -1912 4 45.3411 9.70411 7.93855 -5.0879 -2.60549 -0.62074 -1913 4 45.1871 9.30295 9.44221 -8.90854 -6.98805 -1.17873 -1914 6 39.813 32.3454 29.581 6.89703 -12.1014 5.95535 -1915 4 39.6485 31.4219 29.3549 -7.08038 -1.01192 -10.7476 -1916 4 40.3223 32.2375 30.3827 0.600223 8.34958 5.32896 -1917 6 39.1399 32.1558 8.97291 22.8595 -6.45003 -40.3239 -1918 4 39.6086 32.0592 8.09926 -10.5081 2.64219 35.3633 -1919 4 38.2198 32.2158 8.71089 -7.955 1.72328 8.07951 -1920 6 29.7568 11.3071 40.3305 36.1908 -28.2332 -10.1569 -1921 4 29.0987 10.6276 40.5022 -6.8613 -0.261357 1.73371 -1922 4 30.5966 10.7518 40.2867 -25.0211 23.0598 -1.19829 -1923 6 24.8367 19.8778 29.8512 -3.76004 22.8831 22.3698 -1924 4 24.8428 19.0032 30.2276 -1.20959 -17.1847 2.11456 -1925 4 24.5914 20.4528 30.618 6.24059 -13.3215 -18.0816 -1926 6 50.0702 29.4819 2.87168 7.70946 6.50978 -10.1722 -1927 4 50.8345 29.4231 3.46787 -5.92296 0.441099 -8.02421 -1928 4 50.4135 29.3271 1.96617 -11.3825 0.248157 19.2026 -1929 6 26.3309 13.2577 37.9673 -13.8105 -3.9786 -34.6653 -1930 4 27.2227 13.0528 37.6163 -4.21147 3.58808 27.148 -1931 4 26.2568 13.475 38.8976 18.37 3.27206 13.6317 -1932 6 24.3356 13.8068 16.1475 3.59325 -0.347239 -0.208698 -1933 4 24.7367 14.1162 16.9522 4.68271 -6.41054 14.6744 -1934 4 24.1923 14.631 15.6832 -6.43367 3.48529 -13.6665 -1935 6 21.9593 25.0956 8.01078 27.9223 3.76027 7.52529 -1936 4 22.6404 25.6041 7.51239 -14.7718 -5.75747 5.32796 -1937 4 22.4795 24.6555 8.71494 -11.0917 7.59151 -10.9937 -1938 6 50.1732 25.2931 29.034 -22.8769 -27.0861 -14.4889 -1939 4 50.9231 25.1249 28.4453 9.52927 7.92169 5.9345 -1940 4 50.3853 25.9631 29.6741 16.3661 14.9722 8.20298 -1941 6 23.1854 6.82331 7.6223 5.22953 23.7057 -4.54178 -1942 4 23.9785 7.3899 7.84298 -26.8007 -12.7469 -6.01791 -1943 4 22.4118 7.42329 7.468 18.2581 -13.076 4.30509 -1944 6 6.92213 5.8571 20.8332 2.72627 6.95854 -11.5419 -1945 4 7.54915 6.58218 20.6217 -11.8273 -13.0803 1.39721 -1946 4 6.56012 5.53917 19.9848 5.57208 -2.46181 7.62025 -1947 6 25.395 39.7583 23.949 6.36773 8.3837 -46.9746 -1948 4 25.6324 38.8356 24.0083 0.522678 -6.92882 12.1803 -1949 4 25.626 39.9451 22.9935 -8.38215 2.07882 31.2615 -1950 6 10.8464 30.695 2.12273 2.92699 -11.4721 29.0623 -1951 4 9.93667 30.8598 2.41274 2.41412 3.42254 -4.79395 -1952 4 11.0072 31.0743 1.26994 -5.60296 10.8359 -22.248 -1953 6 23.0784 40.5299 40.0517 -12.8303 7.3127 -19.6888 -1954 4 23.7801 40.7079 39.3995 -2.98216 -3.06267 5.67195 -1955 4 22.2752 40.9489 39.6621 13.0026 -6.04267 8.58422 -1956 6 29.2116 28.3822 37.564 -38.7174 33.0362 -17.1388 -1957 4 28.2182 28.3913 37.3962 39.4392 -4.09178 7.25715 -1958 4 29.4217 27.5495 37.9564 8.20519 -19.4736 9.10227 -1959 6 1.867 12.1738 18.0852 -6.50713 5.08339 -35.4355 -1960 4 2.57398 11.838 18.6163 6.10024 -5.16113 22.8519 -1961 4 1.13063 12.5086 18.5994 -2.48645 -2.83143 13.3981 -1962 6 35.8305 14.0949 8.56039 26.0881 18.3061 13.156 -1963 4 35.1714 13.4739 8.88749 -16.8661 -4.96187 -13.4504 -1964 4 35.7684 14.4109 7.636 -16.9096 -16.2229 2.78164 -1965 6 9.49198 39.8165 37.5846 25.5398 -19.6342 8.10058 -1966 4 10.4488 39.5668 37.3792 -35.3087 19.1509 -1.98674 -1967 4 9.11285 40.4907 37.0027 15.1686 -3.88151 -5.41116 -1968 6 3.54864 30.3444 19.2746 19.2588 -4.84534 25.5649 -1969 4 4.39288 30.8221 19.2218 -5.35887 2.33403 -8.35831 -1970 4 3.69938 29.8 20.0823 -8.98886 6.07327 -15.723 -1971 6 36.3172 32.3761 17.5568 -52.716 -14.5505 -10.7859 -1972 4 37.1181 32.7413 17.8285 45.3049 23.5946 19.1732 -1973 4 36.5447 31.7674 16.8589 0.0557097 -8.91784 -8.34906 -1974 6 22.0674 24.5243 41.4066 13.5104 10.4808 14.5301 -1975 4 21.9193 25.2614 0.114872 1.55544 -1.48024 -5.36737 -1976 4 21.3782 24.5469 40.7428 -11.5581 2.78113 -8.36201 -1977 6 45.7659 15.6016 11.6394 9.02046 4.78635 -7.96304 -1978 4 46.6299 16.0103 11.8091 -2.50167 -1.58301 0.968075 -1979 4 45.9087 14.6499 11.5698 3.7439 -8.72722 -0.994242 -1980 6 22.3679 20.3809 16.0361 -10.6504 -17.4294 -19.3744 -1981 4 21.763 20.3139 16.7773 -4.42579 5.53693 13.3566 -1982 4 23.0073 21.0579 16.2253 11.6801 17.1208 13.2616 -1983 6 25.8325 25.7487 18.9031 6.26908 13.5994 -10.9759 -1984 4 25.2398 26.4837 18.648 3.49723 -12.6326 6.8661 -1985 4 25.3435 25.2434 19.5576 -3.6765 -3.23145 -0.768961 -1986 6 35.3178 34.202 33.2905 -17.6504 -29.1706 1.13026 -1987 4 35.3983 35.1402 33.2641 1.24044 29.706 -1.15043 -1988 4 34.4344 34.0427 33.6774 7.05439 -0.467604 -1.03347 -1989 6 39.2901 17.1075 17.3833 -11.3112 -26.2042 -1.68945 -1990 4 39.9794 17.7123 17.5836 17.425 19.0869 4.79839 -1991 4 38.575 17.6263 16.9966 -1.50153 2.1098 -0.940241 -1992 6 0.398412 14.9432 21.7856 9.03058 1.70326 -1.90296 -1993 4 54.4474 14.9193 21.5731 -3.898 -0.019948 -1.7993 -1994 4 0.528431 14.174 22.3634 -0.170355 0.861544 -0.399335 -1995 6 15.987 23.2263 17.7743 4.36624 14.6934 -7.14303 -1996 4 15.4857 22.9799 16.9684 3.82047 1.22984 7.38673 -1997 4 16.1722 24.1939 17.7179 -4.44652 -15.4901 1.96988 -1998 6 5.24865 11.1141 17.5618 6.95422 37.8037 -9.42255 -1999 4 4.73778 10.3127 17.5906 4.69561 -15.2682 10.3552 -2000 4 6.07662 11.1201 18.0866 -14.6292 -19.4463 0.240297 -2001 6 9.34435 36.7122 13.2675 14.3848 -20.4853 -8.45434 -2002 4 9.62142 35.7704 13.1913 -3.31983 12.7393 -0.467066 -2003 4 9.65952 37.1602 12.4706 -4.49166 -2.86228 3.29419 -2004 6 25.4918 33.5767 0.585194 -13.2513 47.819 -13.0434 -2005 4 25.5067 34.5261 0.924259 2.87868 -31.0124 -5.96193 -2006 4 25.9276 33.0244 1.21144 10.5779 -12.847 23.4116 -2007 6 17.3034 24.3894 31.3332 -3.83374 11.0726 -5.16798 -2008 4 17.6693 25.1812 30.9068 -1.9735 -3.85303 -0.254684 -2009 4 16.6127 24.6926 31.9382 -2.66612 -1.73239 2.61398 -2010 6 50.552 32.7161 27.7939 3.69414 -2.86079 -12.6149 -2011 4 50.6897 33.0491 28.6758 -0.144502 8.45372 13.0825 -2012 4 49.6264 32.8868 27.6344 -12.0524 -1.73095 -4.05681 -2013 6 2.253 37.2274 16.11 8.45807 0.136394 4.49883 -2014 4 3.21927 37.2459 16.107 -3.10104 -5.97474 -11.5471 -2015 4 2.06307 37.5747 16.9848 -8.61924 1.9026 3.91491 -2016 6 25.7683 33.176 8.40354 -18.9203 -11.3347 4.07551 -2017 4 24.8717 33.1921 8.8134 13.9609 -2.48357 -8.81655 -2018 4 25.7602 32.4226 7.7918 -3.67744 3.53954 1.65329 -2019 6 24.768 7.83219 25.4219 17.632 21.1734 16.2998 -2020 4 25.4945 8.36147 25.0103 -20.1597 -14.0103 5.71998 -2021 4 24.2535 7.44908 24.728 -12.2137 -5.73332 -20.4071 -2022 6 44.006 27.3325 21.546 30.1554 -7.9652 -11.3918 -2023 4 43.2457 27.8583 21.7575 -19.7371 1.57643 -2.46296 -2024 4 43.7964 26.4976 21.0884 -11.5694 12.3441 5.98804 -2025 6 20.8391 32.0716 6.72617 12.9902 -8.35788 -26.5741 -2026 4 21.6065 31.456 6.61879 -16.2643 13.1482 10.0653 -2027 4 20.6646 32.3142 7.64123 9.40483 -3.67012 8.54308 -2028 6 0.615177 26.1024 3.99379 -2.52029 5.686 8.70358 -2029 4 0.872898 25.4419 3.3518 0.34785 -8.86692 -8.8337 -2030 4 1.24928 25.9906 4.70547 -1.00806 2.16518 1.82635 -2031 6 23.6932 0.22266 22.8575 19.6208 -9.09848 8.51526 -2032 4 23.2991 1.09802 22.9795 5.26519 -2.66393 -0.960482 -2033 4 24.6108 0.216177 23.2468 -26.6208 7.90328 -9.41734 -2034 6 35.6316 26.9489 6.47476 -11.9227 4.67096 -7.07616 -2035 4 36.2784 26.7656 7.18499 -0.847143 10.2035 -9.59556 -2036 4 35.6247 27.8854 6.12936 11.6979 -23.4314 22.5499 -2037 6 50.1669 7.09081 18.6924 -7.14542 -1.6973 -3.47771 -2038 4 50.8011 7.27946 17.9805 -1.08143 -0.293524 0.841141 -2039 4 49.7425 7.94753 18.8476 4.63932 0.367722 -3.05405 -2040 6 12.4741 14.8288 12.1922 -8.10271 -9.61402 10.4649 -2041 4 11.6958 14.4794 12.6802 13.1948 7.08912 -7.97814 -2042 4 12.1183 15.3251 11.4609 -4.91784 2.70917 -6.99785 -2043 6 52.4614 22.3688 36.3388 -11.0199 -17.3524 -23.0567 -2044 4 51.6251 21.9183 36.1306 -2.17212 11.6706 13.3338 -2045 4 52.9952 21.963 35.6316 8.38603 12.1418 11.4133 -2046 6 41.778 11.4842 39.1192 -2.94788 -8.5466 -71.3066 -2047 4 42.0712 11.6935 39.9642 18.9262 14.1801 48.2999 -2048 4 42.4688 11.7778 38.472 -13.5225 -5.5757 18.7019 -2049 6 13.7869 22.5139 39.1025 -32.0544 -7.10206 -10.9841 -2050 4 12.8164 22.2898 39.2995 40.1723 6.0649 -15.4789 -2051 4 14.0276 22.2847 38.1645 -11.932 2.241 24.8997 -2052 6 28.7471 19.519 21.8427 26.201 -31.4587 -3.42241 -2053 4 29.5077 18.8642 21.7553 -27.3151 19.4313 7.21597 -2054 4 28.709 19.939 20.977 -1.33904 3.86677 -3.41873 -2055 6 8.35104 21.6464 36.3873 -9.70021 11.1463 1.78198 -2056 4 8.59231 22.5715 36.3877 5.92817 6.74417 -5.91108 -2057 4 7.6521 21.6323 37.0621 1.10663 -7.27579 -5.05072 -2058 6 39.9466 23.9759 15.2079 21.5993 -7.98015 -41.1742 -2059 4 40.8727 23.6245 15.2724 -23.8836 11.1149 -0.884493 -2060 4 39.7538 23.9548 14.2182 -0.675121 3.14563 34.0025 -2061 6 8.14826 38.6974 22.5407 10.5164 -8.10765 28.5856 -2062 4 7.68497 39.3831 22.0542 -4.5186 11.15 0.90042 -2063 4 8.43687 39.0737 23.4204 -11.1896 -2.29822 -22.518 -2064 6 10.8609 20.1732 28.9608 12.8413 -0.923384 7.34695 -2065 4 10.0131 19.7426 29.0637 -5.9523 -4.47565 4.1188 -2066 4 10.8844 20.5008 28.0696 -0.703946 5.19258 -12.1525 -2067 6 36.9008 23.822 41.8156 -12.4363 21.7846 -10.0393 -2068 4 37.5711 23.2333 0.167128 40.9996 -19.7248 12.2972 -2069 4 36.1173 23.3131 41.9445 -23.6506 -5.40851 2.0223 -2070 6 23.7894 40.6868 33.3454 12.8596 -15.6087 -7.6142 -2071 4 23.0064 40.9655 33.8068 -12.9523 11.6172 4.83708 -2072 4 23.8763 39.7481 33.6232 3.5481 12.5289 -6.50269 -2073 6 4.67002 19.3025 35.4081 28.9654 -8.37802 15.8464 -2074 4 5.50304 19.0977 35.9037 -20.926 10.8248 -6.78781 -2075 4 4.54874 18.5079 34.879 -7.50763 -2.93955 -6.02594 -2076 6 9.44906 25.7726 10.897 4.32597 -4.58851 8.60165 -2077 4 9.18995 24.8319 10.8983 -5.5655 4.98255 -0.925486 -2078 4 8.69969 26.3126 10.6078 0.159443 -6.7376 0.514864 -2079 6 27.2776 22.4912 13.6121 -0.517147 -7.99313 -8.85992 -2080 4 27.155 21.7331 14.2088 0.0551372 2.14825 -2.63665 -2081 4 27.5226 22.1158 12.7439 -1.12325 6.52643 14.1544 -2082 6 41.0473 18.7721 23.2805 -1.65607 -7.19044 -7.91226 -2083 4 40.4257 18.2083 22.8124 7.09703 -3.21037 0.549063 -2084 4 40.4899 19.4448 23.6465 -2.2525 13.4867 10.2584 -2085 6 46.4847 28.3568 20.1596 21.4343 7.62243 20.4812 -2086 4 45.6558 28.0725 20.6313 23.6124 6.3397 2.68094 -2087 4 47.3103 28.4552 20.7557 -43.4876 -6.08109 -17.1535 -2088 6 14.856 15.3945 30.0569 12.1054 -1.48105 24.8406 -2089 4 14.6669 15.4041 29.1302 -8.67008 -4.83168 -20.7775 -2090 4 14.3859 14.629 30.4429 4.17574 5.50589 -6.96103 -2091 6 23.5299 24.7674 35.2089 8.01546 19.7663 24.3744 -2092 4 22.8065 25.3632 35.4756 2.8295 -9.26237 -7.23473 -2093 4 24.1647 24.8645 35.9517 -5.58112 -4.18239 -8.07128 -2094 6 19.8979 24.2128 28.4372 -8.55524 33.371 -10.5251 -2095 4 20.118 25.106 28.0235 -7.554 -30.7898 14.4583 -2096 4 18.9386 24.2465 28.5992 8.91169 -0.342387 -2.75065 -2097 6 45.9653 7.62821 20.2375 0.645938 -6.46631 40.9505 -2098 4 46.1455 7.81465 21.2011 -4.75538 -9.14986 -26.6761 -2099 4 46.2053 8.42523 19.7798 3.02803 13.7202 -10.1214 -2100 6 38.0274 12.476 8.2804 -12.7973 12.3245 -4.6187 -2101 4 37.3544 13.1993 8.5286 18.4233 -41.2645 -20.6098 -2102 4 37.689 11.8001 7.60922 -1.16355 31.2483 23.3325 -2103 6 46.9232 18.1908 8.45127 -20.6048 6.85227 14.7641 -2104 4 46.2435 17.4987 8.55233 4.56757 4.50302 -0.225601 -2105 4 47.4224 17.9381 7.68168 11.4282 -5.99968 -17.9171 -2106 6 10.854 13.9656 9.37577 10.6617 18.3473 -18.9154 -2107 4 10.3554 14.661 8.90618 -4.87744 -10.6328 11.7585 -2108 4 11.7492 14.0754 8.99486 -7.79483 -7.36366 10.4335 -2109 6 34.413 5.42618 14.0852 -12.6861 0.159125 26.6885 -2110 4 35.1199 5.9296 13.6715 10.4361 -4.78744 -13.6438 -2111 4 34.2786 4.53955 13.7091 11.464 2.02167 -7.62295 -2112 6 0.18261 0.234369 22.9555 2.77695 -16.1069 -0.480131 -2113 4 0.268342 41.6651 22.1144 -0.0234796 4.94264 7.55149 -2114 4 54.831 1.09037 22.7433 -8.12427 18.964 -5.90735 -2115 6 40.9343 30.5497 37.8912 -0.822728 -5.40818 -2.29365 -2116 4 40.0406 30.8803 38.1728 23.6728 -16.1598 5.2797 -2117 4 41.3254 29.8415 38.4693 -14.8835 20.0143 -6.13723 -2118 6 16.6534 17.3205 12.6874 14.7099 15.3782 -9.06546 -2119 4 16.1954 16.505 12.4572 -1.18797 -4.10455 -0.493236 -2120 4 17.006 17.6533 11.8352 -5.05849 -6.69802 12.8635 -2121 6 29.6898 5.4323 24.749 -0.0153423 -4.79708 -9.00604 -2122 4 30.3311 5.93507 24.2276 2.5605 1.293 3.45927 -2123 4 29.9547 5.54756 25.6733 0.859724 2.70473 -2.20341 -2124 6 49.8976 0.279 27.2063 11.3554 -10.6099 9.68168 -2125 4 49.8114 0.578981 26.2935 2.75523 0.634109 -3.06626 -2126 4 50.8097 41.8349 27.2847 -10.6363 5.42595 -5.44518 -2127 6 31.2372 31.739 15.2138 3.99594 22.7956 -4.27207 -2128 4 31.6256 30.8953 15.4507 4.79789 -4.71254 6.82751 -2129 4 31.9624 32.4004 15.1381 -14.4355 -14.737 3.33184 -2130 6 35.7805 24.1465 16.9504 11.9916 -3.59376 -8.04525 -2131 4 35.6914 24.9231 16.3572 2.28972 -11.6943 5.94213 -2132 4 36.6882 23.763 16.8157 -19.8391 7.30154 4.46135 -2133 6 24.2601 4.62781 36.7306 -2.73038 -12.1142 -21.0154 -2134 4 24.8177 5.17448 37.2794 5.25293 5.76293 7.44764 -2135 4 24.6802 4.67277 35.8537 -9.35577 -2.69704 9.81341 -2136 6 17.5719 12.8989 3.66466 27.7221 -13.8379 -12.2911 -2137 4 17.7111 13.5231 2.92461 -8.26776 -5.83385 13.2655 -2138 4 16.7968 13.1561 4.15408 -15.8703 8.33112 4.7305 -2139 6 4.16771 14.2922 18.2601 -1.91899 -29.1082 -10.1028 -2140 4 4.22837 13.3107 18.2109 4.90834 19.7408 -0.578384 -2141 4 3.27435 14.4381 18.5824 -9.9871 6.86755 4.44487 -2142 6 19.1699 36.8381 22.3902 -4.55286 10.0742 -5.97046 -2143 4 18.832 36.3461 23.1414 -4.92402 -9.67799 11.164 -2144 4 19.5712 36.1952 21.8056 6.33502 -12.5333 -3.55186 -2145 6 15.653 11.96 13.2084 19.351 18.6963 0.185202 -2146 4 15.6609 12.833 12.7547 -2.35489 -19.4305 9.56752 -2147 4 16.5767 11.8359 13.5469 -18.24 -1.16426 -6.81767 -2148 6 24.7461 21.9204 5.38797 -27.1503 3.38708 1.08719 -2149 4 25.0422 21.7466 6.29562 -9.42613 0.489783 0.293639 -2150 4 23.7615 21.7936 5.33342 31.5349 -1.60743 10.1723 -2151 6 52.731 18.5617 35.2291 -23.3227 -9.96089 -3.35821 -2152 4 52.3432 18.0885 34.4925 12.0283 -8.22578 -16.7439 -2153 4 51.9379 18.6142 35.7503 -4.18579 12.1235 24.3517 -2154 6 3.56339 27.2782 25.2861 -13.9068 -17.971 -11.9546 -2155 4 3.93933 27.1708 26.1554 6.48024 -2.07304 15.4908 -2156 4 3.97283 28.0403 24.8958 8.97188 17.1762 -5.24442 -2157 6 34.4703 32.9949 30.674 6.71734 26.132 41.1649 -2158 4 33.5303 32.9277 30.8218 -10.267 -13.4259 -20.1884 -2159 4 34.6757 33.5653 31.4552 13.6938 -14.1125 -21.2315 -2160 6 35.2703 23.7477 9.841 1.59588 4.98779 0.126485 -2161 4 34.557 23.9691 9.22977 0.987563 3.83206 0.754652 -2162 4 35.6213 22.923 9.5082 6.82753 -10.3388 -1.5208 -2163 6 42.4139 15.7114 8.97964 24.1102 0.334397 4.42901 -2164 4 41.6569 15.4185 8.4899 -23.1764 -3.9339 -8.15459 -2165 4 42.1019 15.9745 9.85446 -9.30455 -0.897043 1.06511 -2166 6 7.76859 28.8573 32.9442 -15.9037 16.0354 -10.4898 -2167 4 7.97908 28.1549 33.5519 6.36032 -10.9608 11.0673 -2168 4 8.54203 29.0732 32.4131 7.8922 -1.0693 -1.41065 -2169 6 17.6887 41.2397 36.4833 -13.2152 -10.2381 33.1554 -2170 4 16.9194 41.8027 36.6113 -2.7651 1.17246 3.809 -2171 4 17.9462 41.408 35.602 16.1966 5.46369 -29.7656 -2172 6 28.4973 24.2486 15.5471 -12.6583 -10.112 -30.4241 -2173 4 29.1017 24.9078 15.1992 6.65529 6.29726 4.69488 -2174 4 28.2904 23.7156 14.7389 1.39534 3.17619 21.4563 -2175 6 20.9519 16.2974 1.15248 44.1264 9.982 -6.69009 -2176 4 20.9895 15.4004 1.43432 -0.0798072 -22.9414 11.198 -2177 4 20.0538 16.5254 1.09156 -44.6028 7.62895 -2.50253 -2178 6 31.1717 40.7384 5.29995 -1.14335 -24.9234 -14.6262 -2179 4 30.3101 40.4535 4.98914 0.542473 -7.39845 -0.335603 -2180 4 31.0069 41.6267 5.54556 -2.10438 36.1837 12.2935 -2181 6 29.9172 24.7601 36.4536 2.52587 12.7881 -5.39704 -2182 4 30.4095 25.4459 35.9567 -7.35112 -4.48214 8.13095 -2183 4 30.0744 23.9625 35.9621 2.47343 -16.947 -5.4104 -2184 6 8.66853 31.0461 3.90506 3.77884 -22.5587 -9.29968 -2185 4 7.73756 30.8263 3.92016 -7.28297 1.54323 -1.95967 -2186 4 8.75192 31.9258 4.24445 1.80419 26.3875 10.0131 -2187 6 5.53845 32.6958 11.4143 8.71933 -16.8124 -2.49586 -2188 4 4.77303 33.2403 11.6664 3.11219 -11.1916 -2.75881 -2189 4 5.22904 31.759 11.32 0.456358 25.4252 4.80969 -2190 6 45.6505 35.4572 20.4414 3.44959 -7.44503 -2.03407 -2191 4 45.0984 35.4295 19.6379 6.4013 -0.712815 7.57821 -2192 4 46.1919 34.6303 20.4513 -12.6908 13.7486 -3.45541 -2193 6 19.5117 2.78375 9.7759 -32.3978 -9.59039 -17.0694 -2194 4 19.2358 3.70482 9.71872 -0.134373 3.8207 4.89971 -2195 4 18.7417 2.29322 9.36028 25.7327 11.9734 13.3495 -2196 6 54.9587 9.07031 10.9149 6.82732 -5.63024 12.2566 -2197 4 54.8294 8.9199 11.8667 -4.4018 -2.06217 -5.32285 -2198 4 0.663346 9.73371 10.8556 1.49355 -0.124783 -2.42855 -2199 6 21.0387 26.5729 14.7801 20.1883 -1.49652 -44.4677 -2200 4 21.3075 26.2685 13.8316 -13.9911 15.8829 47.28 -2201 4 20.1009 26.3915 14.9175 1.72514 -4.1332 -5.78598 -2202 6 14.1556 30.5195 27.5512 33.9559 3.86758 5.7066 -2203 4 14.6157 30.1887 28.3748 -9.20473 8.28645 -28.3289 -2204 4 14.8625 30.9321 26.9648 -24.7422 -11.1229 20.6028 -2205 6 29.8153 17.3336 31.0863 -17.242 12.2647 2.89366 -2206 4 30.6608 17.508 30.6961 22.1461 -2.37775 -6.86255 -2207 4 29.3509 18.1813 30.9961 -0.156979 -6.11616 8.89085 -2208 6 50.8803 17.2897 27.8178 -36.3925 19.5692 4.68662 -2209 4 49.966 17.6961 27.8739 30.6942 -17.822 -8.40051 -2210 4 51.3989 17.8346 28.4178 4.99425 -5.86793 -0.268148 -2211 6 46.2649 37.0836 13.9834 -5.2064 -3.89214 -29.9265 -2212 4 46.1297 37.5324 14.8008 -1.4234 12.1478 29.9589 -2213 4 45.6025 37.4999 13.3985 5.55615 -7.46483 0.310394 -2214 6 38.1938 37.2652 33.1426 -7.30823 -21.5307 12.8964 -2215 4 38.5245 37.3061 34.0621 0.43181 3.22683 -10.2889 -2216 4 38.5338 38.0078 32.6437 8.99657 15.0472 -1.17828 -2217 6 41.835 13.3432 31.1173 -10.6585 13.9874 21.8211 -2218 4 41.5818 13.8647 31.919 4.55225 -14.0949 -20.2689 -2219 4 42.3932 12.6177 31.4161 6.34511 -7.13184 -1.29627 -2220 6 46.8964 12.6581 17.833 -7.85032 10.4907 -16.4819 -2221 4 46.6484 13.6178 17.7542 4.08188 -24.8978 -7.40371 -2222 4 46.6377 12.1709 16.9987 5.46876 16.7046 19.0746 -2223 6 32.0579 10.0934 10.6503 -8.64381 28.9058 -4.43215 -2224 4 31.7849 9.65569 11.4853 0.173068 15.3159 -11.0765 -2225 4 31.7767 11.0763 10.6467 12.4785 -48.8318 10.7993 -2226 6 34.0094 11.373 6.75969 12.8388 24.8548 11.4886 -2227 4 33.4875 10.5861 6.69386 -15.1181 -21.0438 1.83339 -2228 4 33.7853 11.7772 7.62543 1.85262 -6.17932 -11.7084 -2229 6 45.3294 30.8612 19.494 8.3992 -12.4908 2.66791 -2230 4 45.3133 30.6326 20.4263 -2.2594 2.91399 10.7741 -2231 4 45.8271 30.1094 19.1443 -2.81922 5.63857 -5.34771 -2232 6 20.3557 0.57205 7.14927 -0.865045 4.87397 8.36509 -2233 4 20.1887 0.590785 8.10086 -2.30268 5.48708 -2.96522 -2234 4 20.2885 41.5556 6.94299 -1.24307 -13.5357 -7.1472 -2235 6 15.9783 39.4524 4.13892 -0.0151964 -9.48015 -5.29824 -2236 4 15.6158 39.9898 3.41173 1.6648 1.85694 12.5404 -2237 4 15.64 39.7774 4.99485 -4.20756 5.15612 -10.0141 -2238 6 52.4256 16.4667 25.1127 -17.0507 13.8269 -2.02364 -2239 4 51.8848 16.9346 25.7614 0.982734 -7.60925 5.82434 -2240 4 52.3383 17.0704 24.353 8.48557 -12.5426 -0.219872 -2241 6 38.5361 13.0039 3.23845 15.1533 54.069 38.768 -2242 4 38.651 13.64 4.04305 -2.16968 -28.4467 -44.0011 -2243 4 38.0019 12.309 3.58724 -16.6469 -22.8542 0.297491 -2244 6 35.13 29.6899 31.1766 -32.8294 1.63854 50.8714 -2245 4 35.4825 30.1651 30.4465 16.0479 15.276 -26.3528 -2246 4 34.6741 30.3613 31.7643 12.1102 -21.125 -19.7306 -2247 6 9.51973 33.7498 4.86217 -21.8826 5.77433 4.68556 -2248 4 9.27059 34.3826 5.57285 8.50621 -13.5655 -12.6408 -2249 4 10.3866 33.3952 5.041 8.90701 -1.44023 3.12186 -2250 6 21.534 22.0642 20.5279 -11.3341 -5.53839 17.2976 -2251 4 20.8989 22.7675 20.339 3.51908 1.76985 -0.685914 -2252 4 21.3133 21.7346 21.437 6.74336 6.48682 -22.5749 -2253 6 37.579 11.1901 41.2936 -40.5688 -13.8213 19.6839 -2254 4 37.9154 11.8125 40.6731 20.8822 18.4609 -22.3708 -2255 4 38.2848 10.6639 41.6667 19.2795 -3.39896 1.21846 -2256 6 33.8862 1.42431 38.7362 -9.76991 -12.243 -0.11253 -2257 4 33.6023 0.553369 38.4181 2.20193 5.31751 1.25532 -2258 4 33.9041 1.3558 39.7008 -0.574955 5.51976 -3.65617 -2259 6 4.57166 26.6812 27.9899 28.8485 -45.5436 -4.48952 -2260 4 5.15229 25.8908 28.1565 -23.3183 20.9594 -13.553 -2261 4 4.90489 27.293 28.6243 -0.866291 24.6335 11.5543 -2262 6 10.2514 0.902381 11.6154 -4.58149 -17.6537 26.8062 -2263 4 10.6592 1.12475 12.4668 -4.26503 -7.612 -8.38981 -2264 4 10.5004 1.60734 11.0484 5.83944 23.9466 -26.0443 -2265 6 17.6545 19.8255 2.35686 18.7122 -0.118329 6.29025 -2266 4 17.9031 20.43 1.64019 0.754008 -4.0492 2.7955 -2267 4 18.4832 19.3436 2.60738 -15.0404 10.1651 -4.64219 -2268 6 32.418 25.6758 16.4635 3.6076 24.4214 11.9097 -2269 4 33.0171 26.0095 17.1449 -9.06157 4.09224 -4.99535 -2270 4 32.7904 24.838 16.2462 -1.14602 -28.0291 -11.1265 -2271 6 33.2468 10.6359 0.32388 9.93322 -26.76 -6.12289 -2272 4 32.8861 10.0042 41.5485 10.341 19.2926 16.9559 -2273 4 34.0854 10.2367 0.697563 -23.7256 11.8288 -10.1734 -2274 6 4.94758 4.52061 10.1416 10.7499 4.98188 17.9077 -2275 4 4.04768 4.863 10.1726 -0.273394 -4.88493 2.42241 -2276 4 5.29522 4.53942 11.0694 -10.4701 1.63881 -23.2648 -2277 6 27.0943 16.9779 9.5563 -20.4641 3.47693 -11.2288 -2278 4 27.2045 17.5151 10.3493 -1.38601 2.5137 2.70549 -2279 4 26.2214 17.2494 9.17658 21.4447 -4.2653 12.7286 -2280 6 9.99194 10.5198 19.3763 9.42123 -1.05348 44.8422 -2281 4 10.4342 9.89794 18.8118 9.85784 -12.5922 -17.5865 -2282 4 10.1605 10.162 20.3013 -9.67835 15.4527 -31.558 -2283 6 19.5738 8.53792 27.8563 25.8928 -1.13542 15.4327 -2284 4 20.113 8.77024 28.6584 -12.6361 -5.62488 -23.922 -2285 4 20.1113 7.87775 27.3567 -13.5748 14.3815 9.08869 -2286 6 47.0629 38.9588 23.1271 -13.9792 1.44752 0.432651 -2287 4 47.6691 38.8737 22.3925 4.22694 -4.47738 -4.61135 -2288 4 46.1776 38.8683 22.7344 3.33277 3.24373 3.79368 -2289 6 19.6833 25.3678 11.2608 -44.4501 -0.725843 0.650565 -2290 4 19.0139 24.6272 11.3182 24.6346 19.551 -2.60477 -2291 4 19.1544 26.1629 11.5326 10.4738 -19.1562 -5.87093 -2292 6 27.3884 13.4531 15.7313 17.4935 -10.3398 7.87305 -2293 4 26.7289 13.8255 16.2909 -22.225 11.7393 10.4827 -2294 4 28.1076 13.2654 16.3619 5.43008 -3.78237 -14.8549 -2295 6 18.6476 14.1287 1.42435 5.12245 -4.46092 -43.403 -2296 4 18.3969 15.043 1.25229 -6.07889 7.26273 6.76186 -2297 4 19.169 13.9274 0.593091 -12.995 -1.5013 29.2583 -2298 6 42.2956 22.0175 32.4812 -31.5033 5.69606 -11.9689 -2299 4 42.0953 21.6028 33.3343 -5.26012 -0.0861087 1.91793 -2300 4 41.4492 22.4721 32.2087 27.3869 -15.7461 8.96812 -2301 6 10.0338 9.4525 2.5044 21.0744 -25.1182 9.26795 -2302 4 9.23419 9.82009 2.8603 -22.4046 15.9317 4.21557 -2303 4 10.2146 8.68383 3.09556 -0.513225 11.8796 -14.6695 -2304 6 6.81454 1.43994 21.9965 -17.8896 2.42247 -7.4431 -2305 4 5.91626 1.63042 21.618 24.8197 -16.2049 7.25345 -2306 4 7.09146 0.513113 21.8391 -15.5061 11.1514 -4.64506 -2307 6 11.279 27.0428 18.9739 -2.94846 37.5248 -0.887691 -2308 4 11.8405 27.0241 19.773 -2.49358 0.901506 -7.48985 -2309 4 11.2189 28.0198 18.7087 3.35633 -32.7966 13.2637 -2310 6 41.4624 20.5117 27.2131 -8.71247 23.609 -19.3396 -2311 4 41.6397 21.203 27.8749 -2.09795 -12.5822 -0.139714 -2312 4 41.4581 19.6661 27.6488 3.25287 -9.08293 14.2442 -2313 6 15.4472 24.107 33.4286 7.47915 5.78269 -2.8589 -2314 4 14.6947 24.3175 34.0087 6.10264 -6.26217 -2.67023 -2315 4 15.704 23.1687 33.5026 -8.54671 4.87938 10.939 -2316 6 36.1332 16.3778 10.0175 -2.81296 8.13669 8.31829 -2317 4 36.0433 15.4982 9.63146 0.0153009 -3.05325 1.23302 -2318 4 36.1908 16.2895 10.9807 1.05799 -3.5475 -8.17119 -2319 6 51.7056 16.2618 2.12066 8.195 -18.8618 -27.7488 -2320 4 51.3212 16.7491 2.82948 -13.5116 6.32013 30.1636 -2321 4 51.8333 15.3227 2.36395 -2.62212 15.8907 6.5854 -2322 6 23.4154 8.54771 39.774 19.4785 -4.07885 -14.0827 -2323 4 23.6619 8.92799 38.8876 -4.40964 -10.2511 30.1282 -2324 4 24.1933 8.06554 40.1323 -10.8686 15.1901 -10.9325 -2325 6 36.7652 34.4407 21.0996 -10.7203 -4.0633 -8.35763 -2326 4 37.1575 34.5988 20.2292 -2.24352 0.118594 1.89686 -2327 4 35.7922 34.4168 20.9564 13.0606 -0.027129 3.88767 -2328 6 14.1394 8.88964 27.2822 8.4001 33.0473 -16.3093 -2329 4 13.5583 8.17177 27.4325 -25.1847 -27.8879 6.89622 -2330 4 14.9981 8.62308 27.6007 12.278 -0.771553 4.38 -2331 6 20.6523 37.4857 25.1916 -4.76336 -9.80096 2.89409 -2332 4 20.8435 36.6327 24.7231 -2.60537 24.8018 1.29013 -2333 4 20.5883 38.2205 24.557 2.95927 -14.0914 0.587832 -2334 6 28.8259 24.466 30.0361 -12.0182 1.20484 18.6414 -2335 4 28.1863 24.5363 29.306 15.5663 0.0495978 -2.57679 -2336 4 29.6571 24.0617 29.7579 -0.701354 -5.27936 -13.535 -2337 6 8.3767 11.9994 23.6977 15.286 -11.9681 20.7139 -2338 4 9.3753 12.0245 23.8359 -31.6027 -4.22616 -3.50543 -2339 4 7.96209 11.4264 24.4013 16.8905 14.3689 -13.5243 -2340 6 16.0974 26.6628 22.9497 0.767107 4.93659 2.67852 -2341 4 16.422 25.9025 22.452 -4.69466 0.466105 1.02544 -2342 4 15.3072 26.4353 23.4595 5.90508 -1.9072 -2.1838 -2343 6 22.3492 41.3933 9.48833 17.1541 -15.2597 3.14364 -2344 4 22.6076 0.330473 9.13574 5.89797 15.5422 -4.87712 -2345 4 21.4389 41.4869 9.73785 -21.2641 2.73615 1.78898 -2346 6 49.3865 19.1849 32.379 28.5034 -27.5288 -8.8444 -2347 4 49.9591 18.5119 32.8294 -20.0237 22.3317 -7.01358 -2348 4 48.8882 19.6696 33.032 -5.7885 3.32597 15.4548 -2349 6 29.6797 28.4194 31.2347 -18.17 -6.54897 12.3532 -2350 4 30.6054 28.3362 30.9452 0.112823 -13.8933 8.50124 -2351 4 29.3632 27.6339 31.7874 27.6893 19.0339 -22.4607 -2352 6 5.1089 39.1304 23.5821 16.3589 -26.7425 38.52 -2353 4 5.38369 38.72 24.4786 -14.1195 25.2427 -41.8592 -2354 4 5.12138 40.0884 23.679 1.29424 5.88982 9.05127 -2355 6 42.9406 13.5828 41.5963 2.4548 -20.3274 5.45752 -2356 4 42.752 14.3543 41.1051 4.71299 30.6973 -25.311 -2357 4 42.1302 13.4831 0.159852 -12.9765 -12.2431 17.3873 -2358 6 21.226 12.4267 7.36435 31.2446 -3.521 -2.03074 -2359 4 20.2961 12.4647 7.18572 -19.4619 -2.59914 -12.879 -2360 4 21.5838 11.6146 6.96487 -5.92297 6.31526 1.33966 -2361 6 43.1402 26.8798 37.6925 36.8226 -18.0871 25.2922 -2362 4 42.3701 26.4861 37.2457 1.92095 -10.9538 3.42147 -2363 4 43.8051 26.2366 38.1772 -44.9135 25.1765 -29.4158 -2364 6 19.5374 10.6589 41.6895 -5.57828 -38.0023 -10.1688 -2365 4 19.1336 10.6448 0.637369 -6.5477 2.89313 17.0607 -2366 4 19.8005 11.5407 41.5226 10.6711 39.664 -4.3781 -2367 6 53.6211 10.0725 3.2523 6.57913 5.47914 -9.18923 -2368 4 54.2317 10.83 3.34927 -4.54537 -9.93589 0.0420736 -2369 4 54.0384 9.44833 2.62164 -2.29754 8.8252 9.03809 -2370 6 17.5636 20.1992 28.4305 -16.5699 17.1528 15.5915 -2371 4 18.0548 19.7019 27.7957 9.40873 -10.9714 -15.8242 -2372 4 18.1497 20.2955 29.1876 1.50874 1.07066 2.83373 -2373 6 36.8673 7.33814 1.69171 -42.7001 9.70605 -8.47937 -2374 4 37.6788 7.60022 2.09727 18.2611 10.2246 9.26811 -2375 4 36.4242 8.16776 1.39628 11.5951 -12.345 5.16871 -2376 6 29.225 41.4226 1.83075 -19.1389 21.107 -1.05665 -2377 4 28.4254 0.0289368 2.09685 16.3458 -11.1471 3.47601 -2378 4 29.1672 41.4088 0.871311 7.531 -2.47214 -5.14574 -2379 6 13.5148 3.09025 8.11784 -10.8355 13.5741 -3.86075 -2380 4 12.8447 3.80664 8.08285 8.27234 -10.6709 -2.48032 -2381 4 13.8247 3.09872 9.02804 1.30446 -5.60755 1.07776 -2382 6 15.035 29.5824 18.5052 -13.3664 3.09019 -9.07378 -2383 4 14.628 28.8743 17.9722 6.78876 3.62049 6.93265 -2384 4 14.2975 30.1967 18.6986 12.8362 -2.82157 -1.1162 -2385 6 10.5118 24.7077 24.3903 18.3301 23.9761 -31.3173 -2386 4 10.707 24.7057 23.4146 -4.2845 7.89501 28.372 -2387 4 10.0612 23.8909 24.4849 -17.9274 -27.8 13.6507 -2388 6 2.3293 13.8562 25.1542 8.14415 -2.44132 2.05706 -2389 4 1.63302 13.4321 24.6436 -3.32338 -7.08116 -5.4939 -2390 4 2.0923 14.7815 25.112 -7.52471 9.11743 -0.122921 -2391 6 31.8571 32.759 29.7983 3.65167 10.3578 -8.56752 -2392 4 30.9277 32.9381 29.9784 -0.622435 -3.80813 0.732423 -2393 4 31.8884 31.8723 29.4276 -3.71181 -5.10697 -2.58235 -2394 6 37.531 40.8209 33.967 -23.153 -16.1875 5.3836 -2395 4 37.3251 40.1347 34.6985 0.870468 26.6491 -35.3147 -2396 4 36.773 40.8784 33.3102 18.3716 -9.25033 25.8989 -2397 6 24.0485 38.1313 34.3431 -11.5105 1.837 -35.773 -2398 4 24.1907 38.198 35.2802 9.24451 -7.73664 19.5979 -2399 4 24.4675 37.3552 33.934 1.62169 3.10325 14.1331 -2400 6 37.1852 22.5711 7.36841 5.54302 -17.8805 15.7599 -2401 4 37.6193 21.7136 7.5635 -9.24307 15.2983 -3.07678 -2402 4 37.2973 22.7156 6.43503 3.10694 -1.55352 -15.3513 -2403 6 4.30637 23.241 35.6005 -21.8515 -3.12039 0.833232 -2404 4 4.28153 22.3978 35.1252 -1.17938 4.50836 1.52069 -2405 4 3.36633 23.5034 35.7569 13.5984 -2.36814 -1.35472 -2406 6 15.7372 14.8984 2.68389 5.83394 8.18523 30.6602 -2407 4 16.0581 15.8209 2.80401 -5.66096 -17.7803 -6.78984 -2408 4 15.4195 14.7671 1.79524 0.865375 8.28049 -11.4308 -2409 6 48.1667 23.1873 2.04358 2.14857 -5.2771 -14.5053 -2410 4 48.6748 23.4267 2.82287 11.4848 0.866046 3.26637 -2411 4 48.7964 22.9219 1.32588 -13.3162 5.875 14.6145 -2412 6 24.1221 19.9752 21.5371 -32.3717 23.6383 6.86593 -2413 4 24.143 19.3917 22.3107 11.6246 -2.80692 -10.3828 -2414 4 24.7866 19.7762 20.8968 22.5091 -14.1667 -7.68302 -2415 6 10.5822 29.3968 5.14403 -6.21678 -11.6361 15.7318 -2416 4 9.83188 29.7897 4.67624 10.1791 9.93667 -6.35089 -2417 4 11.4324 29.7717 4.90568 -2.60747 8.99296 -10.7541 -2418 6 5.96985 27.6957 31.2251 14.0826 -21.4471 -14.909 -2419 4 6.62108 27.1001 30.7651 -15.2176 13.0885 7.83628 -2420 4 6.49554 28.1541 31.8886 3.5811 4.10899 4.91189 -2421 6 18.524 25.7945 15.3346 -6.80319 -1.26411 -41.3947 -2422 4 18.3129 25.8537 16.2191 -1.03447 -6.47723 71.4836 -2423 4 17.8509 26.3975 15.0287 -5.96066 9.61194 -22.438 -2424 6 52.0911 37.2147 11.1191 10.7944 -12.7592 -3.2574 -2425 4 52.6735 36.5031 10.7991 -6.06835 6.24709 5.19982 -2426 4 52.6754 37.9802 11.2539 -6.64808 -1.57102 -0.449092 -2427 6 46.8545 14.6154 7.32174 -10.4102 9.08531 6.17155 -2428 4 46.1761 15.2305 7.76384 29.9054 -34.6086 -7.32766 -2429 4 47.196 13.9114 7.91569 -13.0839 18.0399 0.731203 -2430 6 22.2426 0.701706 41.6733 41.1626 12.534 -29.9538 -2431 4 22.236 1.66756 41.6378 -9.79705 -6.68715 4.90956 -2432 4 23.0808 0.492341 41.1545 -29.2322 -0.545859 23.5967 -2433 6 4.06645 14.7285 9.26505 -5.79968 22.7562 -12.5209 -2434 4 3.53709 15.5501 9.07402 9.13976 -21.8289 3.48331 -2435 4 4.94549 14.9564 8.94351 2.1847 -1.50717 0.750146 -2436 6 37.293 12.6643 37.0348 -15.3153 -6.18171 16.0178 -2437 4 37.7524 12.8164 37.9019 -17.8573 -2.14895 -9.99561 -2438 4 36.3666 12.3049 37.1727 33.7628 8.85249 1.83374 -2439 6 26.6624 29.0693 40.5955 -26.637 27.4899 13.7151 -2440 4 27.0962 28.2693 40.8235 19.1059 -29.7051 -2.9078 -2441 4 26.7436 29.2635 39.6647 9.93266 -1.33043 -11.4317 -2442 6 7.23743 13.8563 3.32048 -33.1041 -30.3754 -14.41 -2443 4 7.96064 14.4301 3.56742 25.5688 -7.52041 0.820923 -2444 4 7.42976 12.8854 3.09984 6.81051 43.2082 15.4509 -2445 6 8.94797 34.8532 28.8254 23.4184 -23.2786 -12.4265 -2446 4 9.89546 35.0323 28.6727 -12.7097 -5.00209 3.03018 -2447 4 8.59604 35.6886 29.0779 -14.3686 23.8739 12.2374 -2448 6 37.2014 40.0808 40.1141 12.7521 0.43192 13.6168 -2449 4 36.2619 40.0837 39.9632 -10.4254 2.72875 -6.67898 -2450 4 37.248 39.4512 40.8496 7.71934 0.19736 -2.65382 -2451 6 30.3728 6.17428 27.2502 2.34222 12.9127 24.6773 -2452 4 30.0491 5.75377 28.1093 17.5599 21.8776 -23.7977 -2453 4 31.0277 6.90628 27.4549 -18.5498 -22.5685 3.02853 -2454 6 10.4851 22.8816 18.2947 -6.39025 -14.7202 -25.3901 -2455 4 11.3539 23.0451 18.66 8.78619 -1.44678 0.615593 -2456 4 10.601 22.3432 17.4702 -0.435219 15.7289 22.4338 -2457 6 35.9047 14.2516 40.1476 -11.9566 8.08227 -8.12446 -2458 4 35.3828 14.5983 39.4171 17.9635 11.5828 -3.36223 -2459 4 35.2535 13.6726 40.504 -8.36759 -16.975 21.7169 -2460 6 6.70775 1.0715 17.7189 7.50642 -21.2746 -7.36561 -2461 4 6.22784 1.34485 18.5084 1.44497 -10.5234 3.95628 -2462 4 6.91772 0.0894674 17.7256 -13.4419 30.1572 13.7277 -2463 6 41.3365 34.0623 33.1636 23.1157 -5.84267 13.8333 -2464 4 40.4227 34.234 32.9444 -15.3258 11.3352 -14.6542 -2465 4 41.9184 34.5849 32.5841 -12.4833 3.91505 -3.84565 -2466 6 37.2858 0.99342 41.2878 7.36827 13.3221 -16.8172 -2467 4 37.4859 0.112276 40.9658 -1.88555 -12.2628 0.361589 -2468 4 37.4834 1.0172 0.312287 5.29267 -3.40266 15.6364 -2469 6 25.2541 30.9749 6.2071 -22.7336 2.5299 17.3506 -2470 4 26.0217 31.2424 5.69829 1.89843 -3.96463 -15.2281 -2471 4 24.4182 30.8551 5.69564 23.045 5.74277 3.20871 -2472 6 14.1871 24.4929 28.313 -6.35756 40.4048 -1.58139 -2473 4 14.3311 23.6816 28.7714 -3.10946 -31.1704 -0.0360927 -2474 4 13.792 24.4319 27.4273 2.40698 -14.1025 6.50138 -2475 6 34.2078 26.2332 36.0169 -41.3887 31.6455 20.302 -2476 4 35.1375 26.2713 36.1926 18.3831 1.21525 6.50399 -2477 4 33.7458 26.9646 36.5669 26.0782 -29.6148 -21.0343 -2478 6 32.3696 8.32545 27.9988 -31.7689 14.924 14.5852 -2479 4 32.5206 9.30939 28.0669 10.5891 -30.1429 -9.37737 -2480 4 33.1235 7.86931 27.6333 20.3768 10.5357 -6.59273 -2481 6 11.7881 0.276326 26.9686 -1.26514 -24.1343 -2.09554 -2482 4 11.7898 41.2288 26.6922 -1.19404 21.3361 9.01519 -2483 4 11.5977 0.31005 27.9205 2.09711 -1.6438 -10.9729 -2484 6 1.68282 0.256654 10.3371 7.78574 -7.1909 -12.7427 -2485 4 1.59984 41.2742 10.69 -0.913761 -2.35777 -0.20094 -2486 4 1.41183 0.821253 11.0453 -5.61238 10.3042 16.839 -2487 6 6.75659 13.8554 8.24275 2.15336 8.75665 -12.4729 -2488 4 6.4538 13.9004 7.29654 11.603 6.79512 25.9161 -2489 4 7.29723 14.6482 8.44053 -3.39366 -6.31817 -8.96948 -2490 6 22.229 20.5516 6.16712 -19.4021 -6.23502 11.2792 -2491 4 21.7175 21.3783 6.29668 6.22315 -10.0472 -0.391558 -2492 4 21.7004 19.8262 6.58709 9.33903 15.1246 -7.94106 -2493 6 17.3809 20.4508 10.8712 -6.33142 3.08518 -4.04876 -2494 4 16.5461 20.08 10.4568 21.8919 23.129 5.85777 -2495 4 17.5363 21.4129 10.6625 -13.97 -26.3983 1.7074 -2496 6 17.7006 4.52466 19.5892 5.66371 -4.97651 -9.86024 -2497 4 16.9376 4.52739 20.1892 -4.06273 -5.34645 -7.80596 -2498 4 17.5412 3.84457 18.8839 -0.885651 16.9891 23.3258 -2499 6 0.475545 18.1168 40.0844 5.30586 -7.45209 -16.0452 -2500 4 0.255658 18.7395 40.7612 -0.602959 14.3131 10.4938 -2501 4 1.33302 18.3868 39.7002 -7.70736 -6.31105 3.74686 -2502 6 22.9439 24.8338 27.8349 -3.23408 23.09 -51.7359 -2503 4 22.7283 25.5292 27.1178 5.97449 -27.0764 31.3639 -2504 4 22.8278 25.2464 28.677 -4.11703 14.8593 21.0934 -2505 6 42.7959 39.1553 26.7627 -13.6288 14.9904 24.3142 -2506 4 42.9559 38.4383 26.1586 10.7263 -7.78522 -15.113 -2507 4 43.351 39.9224 26.5692 3.77188 -7.24305 -5.18193 -2508 6 26.2354 3.05796 21.7982 1.74018 25.1467 -10.7915 -2509 4 25.6923 3.78105 22.1642 10.9011 -13.8467 -3.1836 -2510 4 26.7888 3.50003 21.1142 -10.0122 -11.5362 10.4851 -2511 6 54.6007 9.88011 29.5829 2.61324 -0.835643 16.9334 -2512 4 53.983 9.1383 29.6239 1.49377 0.577448 -2.59463 -2513 4 54.746 10.0983 30.5296 -2.21833 -1.79811 -18.9561 -2514 6 24.7578 33.7363 20.5387 -17.5006 5.04967 -0.0763559 -2515 4 24.6934 34.6555 20.8512 7.60819 -4.12262 3.6003 -2516 4 23.9235 33.6132 20.0554 5.3121 -3.42637 -1.44671 -2517 6 41.6963 16.3109 0.897802 2.88421 10.066 -28.0255 -2518 4 41.3077 16.0362 1.70176 -16.3219 -5.78099 30.2108 -2519 4 42.6299 16.1901 1.06805 12.6035 -3.11322 -2.97519 -2520 6 23.404 27.9303 27.4821 -1.06023 20.2241 -21.3645 -2521 4 22.8141 28.2554 28.1835 2.551 -1.87769 -8.73241 -2522 4 23.2629 28.4828 26.6516 2.17993 -16.4871 31.3925 -2523 6 32.7813 37.2936 18.7328 38.5641 -14.7697 6.75932 -2524 4 33.752 37.1016 18.9061 -34.9795 -0.437252 0.892363 -2525 4 32.8311 38.1729 18.3762 -6.70298 14.6722 -8.07554 -2526 6 21.2305 27.6771 4.7955 -18.4608 -25.795 -24.9287 -2527 4 20.5062 27.4644 5.39651 2.92048 5.31567 1.45057 -2528 4 20.941 27.2184 3.94502 12.5509 18.4099 23.8236 -2529 6 54.9409 17.9571 1.83459 -7.07205 6.42915 6.55936 -2530 4 54.7029 17.1381 1.42965 7.06691 -21.815 -7.49321 -2531 4 54.119 18.4405 1.74821 -9.38537 8.8513 -0.363257 -2532 6 36.7335 10.6984 6.58912 -34.5362 -0.324761 -4.53473 -2533 4 35.7609 10.9799 6.6143 34.1258 -12.1011 2.72213 -2534 4 36.7696 9.77633 6.90859 -3.13742 6.31851 -1.30765 -2535 6 54.2706 4.50024 14.0257 -11.269 5.99606 -15.4247 -2536 4 53.8536 5.11876 13.3604 4.87759 -11.992 26.1673 -2537 4 53.895 4.59469 14.9192 -3.76531 8.72829 -7.53187 -2538 6 22.107 12.8255 32.0148 27.0088 -6.82073 4.3703 -2539 4 21.2061 13.1328 31.8952 -10.7145 6.62508 -9.34344 -2540 4 22.7298 13.2576 31.3917 -17.4011 -3.99159 8.00208 -2541 6 15.2931 36.6619 4.04206 -24.4039 12.3238 20.1693 -2542 4 15.3606 37.6342 3.9855 6.08423 -9.62309 -2.22716 -2543 4 16.0243 36.2999 3.55051 12.1414 -1.28609 -8.9598 -2544 6 23.9518 1.27347 5.70825 1.82336 16.8815 15.3992 -2545 4 23.158 0.731739 5.71694 -5.31944 -7.03749 -3.2154 -2546 4 23.9846 1.73289 6.57368 -1.26671 -8.46254 -14.2674 -2547 6 14.3069 12.6571 15.8074 -11.3886 -13.8779 -22.9988 -2548 4 14.4908 12.4438 14.8835 17.1875 4.58775 1.43504 -2549 4 13.3991 12.3171 15.8566 5.60683 8.95198 18.2444 -2550 6 15.0463 40.2277 6.58272 -14.4539 15.1029 5.15073 -2551 4 15.8086 40.489 7.08192 22.3652 -6.01515 7.9389 -2552 4 14.4962 41.022 6.75392 -6.77819 -16.9793 -13.6053 -2553 6 48.5629 32.6194 12.091 2.37027 -5.84764 -3.4739 -2554 4 48.1048 31.8776 11.6348 7.57669 12.4587 1.43975 -2555 4 49.3373 32.9111 11.5511 -18.0393 -12.2542 5.39731 -2556 6 11.2883 31.5349 7.21941 -5.75599 -10.1169 -16.3625 -2557 4 10.675 30.8987 6.79271 12.7122 10.5617 8.56414 -2558 4 11.681 32.0415 6.48473 -4.52974 -6.63428 7.17241 -2559 6 30.1204 27.9925 10.216 2.65146 5.67665 0.571004 -2560 4 30.7332 28.7325 10.019 -7.63861 -11.6097 -0.594568 -2561 4 29.9063 27.5181 9.39417 2.857 4.22172 -1.33476 -2562 6 27.6817 22.1076 17.3717 2.13561 -8.21554 7.46684 -2563 4 27.3138 21.4721 16.7296 5.88092 9.15558 -3.1228 -2564 4 28.0594 22.8778 16.9197 -3.27829 -5.84867 -5.86393 -2565 6 12.9588 4.5965 18.1625 2.45174 -26.8216 -12.137 -2566 4 13.4346 3.75914 18.3684 -5.38503 16.4797 0.486183 -2567 4 12.5704 4.4145 17.2814 1.35975 11.1796 8.84538 -2568 6 19.7171 6.72206 19.0824 18.7149 18.1076 8.78634 -2569 4 19.0276 6.07043 19.1643 -12.8479 -14.7766 2.48779 -2570 4 20.149 6.78349 19.9504 -8.03044 -1.70313 -8.42964 -2571 6 37.158 31.386 11.4948 13.5333 -6.17925 -0.534196 -2572 4 36.3748 31.5241 12.0574 10.6691 -10.2998 8.4252 -2573 4 37.8298 30.7884 11.9154 -26.2348 9.80485 0.777976 -2574 6 3.12167 16.2038 27.3537 -19.2499 -26.3416 -14.9115 -2575 4 2.564 15.4232 27.613 17.9651 21.4634 -3.17821 -2576 4 3.05771 16.2343 26.3741 -0.0558506 5.44355 20.7735 -2577 6 15.7152 9.97508 38.3617 37.2659 20.4939 22.6587 -2578 4 16.1689 10.8384 38.1525 -17.0523 -25.976 5.55091 -2579 4 16.2475 9.64647 39.1327 -18.0975 2.21635 -20.7757 -2580 6 13.3945 14.2914 8.22355 52.7406 24.0557 20.8129 -2581 4 13.9343 15.0997 8.53617 -32.8018 -27.7376 -11.9171 -2582 4 14.0669 13.5802 8.35008 -24.0553 1.67412 -6.96019 -2583 6 1.72299 24.3133 36.3936 32.5837 -28.3335 21.1288 -2584 4 1.96116 25.1215 36.8464 -1.44419 12.4956 -1.11134 -2585 4 1.10799 24.5417 35.7277 -24.491 15.1488 -24.3141 -2586 6 11.1925 26.5189 32.9725 1.88857 3.23229 20.5962 -2587 4 10.9062 26.8258 32.1286 -6.138 -2.28585 -27.1412 -2588 4 11.0637 27.2989 33.5293 3.02186 -7.15206 7.83107 -2589 6 29.5898 0.769141 36.29 0.770047 10.6645 18.3277 -2590 4 29.1085 0.54227 35.5145 -3.81283 -13.529 -27.0487 -2591 4 28.8904 1.11515 36.8518 6.86702 4.29265 4.12775 -2592 6 43.6054 13.1224 23.9122 -2.46968 6.93561 -17.1322 -2593 4 42.8447 13.3401 24.4619 -4.47847 1.10283 0.728731 -2594 4 43.3126 13.2067 22.9653 4.50753 -0.208477 27.3689 -2595 6 7.45217 19.7807 19.6677 5.33955 -1.6221 -12.877 -2596 4 6.80427 19.1226 19.9251 -3.45906 -4.13396 8.35684 -2597 4 7.46466 19.745 18.7046 0.226191 5.91599 3.73904 -2598 6 24.4186 4.28854 7.83154 -9.27237 -3.93777 -5.86373 -2599 4 24.1141 5.19611 7.95791 2.72117 -5.11917 -0.666563 -2600 4 25.0574 4.07609 8.5187 1.73531 2.38301 -0.0162684 -2601 6 51.4783 30.2365 31.1578 4.43663 8.1051 17.8753 -2602 4 50.5719 29.9409 31.3316 -1.01079 -0.531629 -9.26743 -2603 4 51.6665 30.2531 30.2149 -6.58635 -1.64064 -12.0931 -2604 6 0.928618 23.6677 16.8891 39.1558 -2.20072 16.2176 -2605 4 0.0728448 23.4362 16.5368 -6.93512 -13.3273 -6.91209 -2606 4 1.45563 22.867 17.1505 -20.9828 13.2836 -9.64814 -2607 6 45.0876 19.3948 15.692 7.86589 27.8079 -34.4593 -2608 4 45.9117 18.9264 15.546 6.38244 -8.87865 2.87525 -2609 4 44.6429 18.9609 16.3882 -19.7965 -22.2098 30.8606 -2610 6 17.4975 8.71947 40.5884 -15.3884 33.6574 -8.04213 -2611 4 18.1832 9.38307 40.741 -0.0730079 1.31818 -0.306908 -2612 4 17.9142 7.90906 40.8182 15.4372 -26.466 6.58932 -2613 6 30.1853 27.2566 27.195 -12.9952 17.3445 1.1523 -2614 4 31.1231 27.467 27.0889 -0.851996 0.391463 0.93648 -2615 4 29.6983 28.1205 27.2412 18.1484 -22.709 -4.59112 -2616 6 43.0643 26.2027 28.3545 -5.31946 22.0639 -20.7107 -2617 4 43.281 25.753 27.5201 1.76973 -3.45008 6.18356 -2618 4 43.0898 25.5645 29.0616 2.35339 -12.574 6.70826 -2619 6 27.9963 7.58777 3.05558 10.5798 9.34284 19.8534 -2620 4 28.0446 6.83168 2.47717 -2.58104 -14.3156 -10.0889 -2621 4 28.509 7.35692 3.86128 -6.64638 2.01122 -8.68086 -2622 6 44.6822 7.22369 10.1895 -15.4824 21.4485 13.7445 -2623 4 44.4465 7.45383 11.1264 7.27839 -9.51736 -18.1425 -2624 4 45.2115 6.42757 10.2073 4.94307 -7.89984 8.76143 -2625 6 23.5336 20.3897 32.2571 -4.86538 -1.36788 -16.1605 -2626 4 23.3032 21.2113 32.7104 1.28111 0.523216 5.34569 -2627 4 23.9774 19.8232 32.8948 2.81274 0.218846 6.19737 -2628 6 37.5478 21.0473 29.278 -18.5062 7.79735 6.57819 -2629 4 37.2371 20.358 28.6908 4.72073 -14.165 -12.1471 -2630 4 36.7158 21.4163 29.628 13.2175 4.90017 2.66375 -2631 6 49.286 29.0703 28.699 10.8186 8.22027 -9.31733 -2632 4 48.7028 29.7991 28.456 -10.3299 -0.414367 -0.610456 -2633 4 50.1517 29.4276 28.433 0.637469 -9.81751 4.99071 -2634 6 47.52 18.1671 15.2208 -2.7229 30.7912 -34.1138 -2635 4 48.0078 17.7317 15.8928 12.2019 -13.0526 25.5862 -2636 4 48.0044 19.0008 15.0204 -10.6208 -16.322 3.06818 -2637 6 23.2448 11.1727 16.5931 -14.8157 -11.6244 -0.308602 -2638 4 23.8342 11.8286 16.2582 11.4387 21.3683 -6.30591 -2639 4 23.6559 10.3501 16.3116 -3.14365 -5.23997 2.15847 -2640 6 3.13911 8.33446 23.1963 -2.69702 8.14317 3.16076 -2641 4 3.4034 7.82956 22.4196 3.11719 -1.75335 -2.44085 -2642 4 3.61355 9.18537 23.1574 -2.855 -3.87959 1.25156 -2643 6 0.502965 16.1866 6.18545 3.06312 3.24934 37.7622 -2644 4 1.47856 16.2897 6.04903 -24.0003 -4.70784 4.68468 -2645 4 0.309706 16.1237 7.18858 13.4295 2.89967 -42.1744 -2646 6 43.1771 15.7066 5.83749 -5.07319 -7.51407 -5.60477 -2647 4 43.0136 16.4204 6.43488 -7.5966 11.2789 14.4199 -2648 4 44.0623 15.8898 5.5251 15.5631 0.134699 -7.60204 -2649 6 16.7019 35.4798 34.4572 -11.2013 7.16284 28.6023 -2650 4 15.9782 34.9492 34.0738 5.35466 1.61493 8.45244 -2651 4 16.3895 35.7941 35.362 6.52255 -9.83405 -29.4813 -2652 6 38.8822 7.74245 15.6771 24.467 26.2162 11.5837 -2653 4 39.1941 7.06316 15.0707 0.325231 -3.95447 -5.25413 -2654 4 39.6937 8.2709 15.9758 -30.2905 -22.5291 -12.0432 -2655 6 42.0043 36.5204 13.6369 3.57579 19.2035 0.0265624 -2656 4 41.9371 35.5667 13.6578 -6.58441 -9.91584 1.38486 -2657 4 41.1548 36.8737 13.3269 0.670997 -7.61264 0.497391 -2658 6 54.2965 15.3698 32.1203 7.94984 -1.57724 11.6593 -2659 4 0.00278476 15.9714 32.4364 -1.97539 -6.90512 -0.0853595 -2660 4 53.6257 15.9484 31.7567 -4.83125 0.736868 -4.95397 -2661 6 22.8953 13.994 39.0277 29.317 0.766946 3.70607 -2662 4 23.2673 14.8115 39.3939 -3.87119 -6.48985 -1.20924 -2663 4 21.9724 14.1463 38.894 -27.0425 2.87882 -4.26486 -2664 6 48.0413 28.5291 4.79053 -11.6037 -2.58599 22.6989 -2665 4 48.6027 28.7991 4.07655 16.555 3.34212 -19.6439 -2666 4 47.7045 29.3636 5.15455 0.064426 -0.719185 3.47056 -2667 6 48.8324 10.6079 2.66689 -4.06073 -3.45613 -38.269 -2668 4 48.225 10.1372 3.21562 -13.339 -11.2438 14.6703 -2669 4 49.3888 11.1314 3.20945 16.7197 17.33 23.918 -2670 6 17.1017 29.3417 4.42129 -6.1746 1.2215 19.6287 -2671 4 16.2515 28.9749 4.73431 4.06151 0.983408 -5.41825 -2672 4 17.5169 29.7258 5.22535 1.37581 -6.66399 -13.2687 -2673 6 27.7925 7.31966 26.5665 39.3465 35.5797 -5.30427 -2674 4 28.7629 7.09708 26.703 -34.5848 -6.71948 -0.628584 -2675 4 27.2286 6.57009 26.6643 -1.86949 -31.2701 4.24572 -2676 6 18.0221 22.0409 22.5172 -16.5701 10.2349 -21.3339 -2677 4 18.5639 21.2383 22.5163 -1.8186 -3.43948 -8.36361 -2678 4 17.5144 22.1102 21.6408 22.068 -10.0871 32.2991 -2679 6 22.1395 25.0891 16.7042 -20.9036 23.9116 7.05274 -2680 4 21.7854 25.6501 15.9625 11.5166 -19.4533 18.3362 -2681 4 22.5191 24.3092 16.3181 5.92374 -8.20656 -11.3677 -2682 6 25.488 28.4523 7.12785 -10.8823 -15.9396 20.8595 -2683 4 25.4981 28.5494 8.12476 3.48758 8.16016 -33.1398 -2684 4 25.5521 29.3092 6.69674 -1.4246 11.8198 7.49476 -2685 6 42.5416 24.7341 23.7389 -17.4504 20.5814 2.46415 -2686 4 41.7374 25.1978 24.1118 21.637 -12.0739 -8.95046 -2687 4 42.3838 23.7928 23.8344 -7.43983 -12.597 1.84916 -2688 6 6.22002 16.6178 2.47863 15.1987 22.5956 5.3052 -2689 4 5.33799 17.0017 2.41879 -13.1624 -14.3434 -0.0608379 -2690 4 6.24934 15.6649 2.55192 -10.5885 -12.312 -0.729605 -2691 6 47.3735 33.281 1.45237 -1.26376 -9.34891 -34.4477 -2692 4 47.004 34.1558 1.53803 -0.151384 8.42018 6.19826 -2693 4 47.7374 33.0316 2.29181 5.29029 2.56444 17.845 -2694 6 1.28124 36.1882 24.8833 15.6174 10.404 -23.7919 -2695 4 0.591937 36.4933 25.4703 -7.67557 -4.15788 11.0948 -2696 4 1.63511 35.375 25.2549 -3.92235 -3.89482 10.8998 -2697 6 20.9296 29.0485 16.4244 -14.8946 8.72798 0.140185 -2698 4 21.4494 28.4837 15.8729 6.14594 -21.5718 -11.6475 -2699 4 21.5122 29.7657 16.643 5.64358 11.2813 6.66084 -2700 6 18.6504 32.5428 14.1464 30.5599 1.70581 -2.73789 -2701 4 17.8579 33.056 14.2705 -20.3424 -4.20043 8.80032 -2702 4 18.5989 31.5954 14.3835 -16.0449 10.8642 1.76069 -2703 6 15.729 41.6925 0.00385817 -5.28292 -15.868 -0.0471225 -2704 4 15.6317 41.084 41.1283 -1.722 11.921 23.9575 -2705 4 15.1873 41.3899 0.782005 8.67232 1.52126 -23.9336 -2706 6 20.5292 18.4098 7.21323 -2.91221 4.89049 5.17577 -2707 4 20.2914 18.5583 8.16487 -5.028 -0.721877 -18.2737 -2708 4 19.7413 18.3526 6.62958 8.30767 0.291632 18.8261 -2709 6 35.3342 2.82915 1.61883 3.51298 26.3767 19.1091 -2710 4 35.0331 3.19583 2.50754 16.3791 -7.36031 -35.2043 -2711 4 35.9206 3.53855 1.22039 -16.4006 -18.5858 14.5973 -2712 6 48.9922 19.6721 24.94 -34.075 0.0390245 -1.22883 -2713 4 49.8199 19.2352 24.7823 16.5976 -0.114011 -0.96393 -2714 4 49.1617 20.6125 25.0649 5.94448 -3.86752 4.03728 -2715 6 26.0294 7.18427 41.5679 18.6543 -22.0446 -14.9111 -2716 4 26.7755 6.56315 41.735 -11.6555 11.6244 -4.08136 -2717 4 25.6575 7.3193 0.515359 -11.3234 5.2253 22.1616 -2718 6 22.0232 3.61039 29.0191 -5.74486 -2.38085 -7.46091 -2719 4 21.2539 3.82496 28.4513 11.98 3.27859 6.66273 -2720 4 22.2148 4.35673 29.5966 -4.60401 3.08527 0.791206 -2721 6 27.8512 32.5337 20.6565 16.709 -10.0789 14.6393 -2722 4 26.9625 32.7469 20.4552 -34.4793 1.21347 -3.16249 -2723 4 28.3469 33.1233 20.1026 12.1012 5.18966 -5.24336 -2724 6 8.41229 24.7869 3.46082 22.3386 15.1563 9.53263 -2725 4 8.90357 24.2552 2.84068 9.55631 -8.44952 -10.853 -2726 4 7.60423 24.3318 3.61908 -22.8615 -12.1417 2.22131 -2727 6 30.5897 41.7312 15.6484 22.6974 7.2585 28.5546 -2728 4 29.9644 0.0840213 16.3484 1.9076 -3.76769 -8.41354 -2729 4 30.1014 41.5664 14.8669 -20.7398 -7.21626 -25.2002 -2730 6 48.088 5.62638 21.1953 6.60529 -8.20232 0.106871 -2731 4 47.6746 6.34733 20.7055 -8.23977 -5.05625 1.96425 -2732 4 47.4017 5.06013 21.5879 -0.150274 10.975 -6.21391 -2733 6 39.4216 23.1741 35.7526 -24.6601 -13.9913 -21.1364 -2734 4 39.9113 23.6202 36.3986 28.8985 24.9348 33.8823 -2735 4 38.8958 22.5444 36.2533 -4.57276 -5.65639 2.90172 -2736 6 51.5794 33.3637 5.78804 -15.2387 -43.0642 -16.4958 -2737 4 51.7543 34.264 5.94613 8.32006 43.2545 8.99501 -2738 4 51.5314 33.243 4.82206 1.27667 3.09716 8.04215 -2739 6 40.1245 17.6149 30.7901 8.56984 -3.86721 -1.09973 -2740 4 39.7659 18.4612 31.0527 -2.58034 0.199434 5.42908 -2741 4 40.7245 17.8709 30.0792 -0.880063 -10.8459 -3.09375 -2742 6 46.409 9.80599 18.5787 -10.6525 10.5445 16.3312 -2743 4 47.1858 10.3579 18.4839 1.73901 1.20814 1.97642 -2744 4 46.4156 9.2339 17.8265 -1.18405 -17.3223 -19.0152 -2745 6 15.8964 41.084 31.9275 -7.67529 -16.3413 6.36199 -2746 4 16.5726 40.6297 31.3851 0.744388 15.1086 2.48527 -2747 4 16.0838 0.121849 31.9545 10.6182 0.477469 -6.79561 -2748 6 48.5579 25.7373 14.9245 -32.9201 0.62376 14.4593 -2749 4 49.4842 25.8337 14.7718 19.5896 2.21134 -17.0603 -2750 4 48.049 25.8802 14.1037 15.4245 2.93063 1.46628 -2751 6 39.2312 28.9787 36.1455 -14.672 -4.00104 3.01304 -2752 4 39.9934 29.3216 36.628 6.25522 6.25199 -7.03146 -2753 4 39.4638 28.7366 35.2366 10.4577 0.0924929 -3.6403 -2754 6 37.3289 21.0516 14.9314 -10.8689 -7.09111 1.49701 -2755 4 38.071 20.892 14.3011 -28.0288 10.0477 -1.14031 -2756 4 36.4673 21.3942 14.5393 36.2132 -8.93414 7.14583 -2757 6 32.4934 22.8531 15.7417 3.10645 -11.4389 20.7178 -2758 4 31.7266 22.539 15.2235 4.17967 -1.79737 6.20971 -2759 4 32.6084 22.2825 16.5528 -7.19864 12.5613 -26.7488 -2760 6 18.5678 8.15053 37.5885 12.1963 17.253 1.38788 -2761 4 19.2402 8.85275 37.7813 -15.6951 -12.294 2.78452 -2762 4 17.9606 8.11124 38.3342 2.60008 5.05619 4.87993 -2763 6 46.9436 30.3797 11.0104 1.88703 -1.83756 -2.66296 -2764 4 46.4577 30.6986 10.2121 16.8565 -15.5671 12.8865 -2765 4 47.4104 29.5424 10.7815 -11.8828 15.01 -3.66074 -2766 6 54.6316 13.0448 30.6676 -4.47091 -6.8042 2.85617 -2767 4 54.8929 12.2323 31.1402 -1.2342 7.60269 0.15722 -2768 4 54.6603 13.771 31.309 -0.297949 0.849652 -1.52079 -2769 6 32.2951 35.1224 27.9786 -1.77947 21.9995 15.3623 -2770 4 32.2792 35.8643 28.662 -2.01418 -27.5067 -15.3374 -2771 4 32.1621 34.2527 28.3767 0.559318 -0.0892981 14.8897 -2772 6 4.45055 25.4036 31.7899 -1.02142 -16.2715 16.4968 -2773 4 4.99753 24.9958 32.4777 -6.33224 -6.47315 3.67169 -2774 4 4.91071 26.2154 31.6821 9.55032 31.2277 -12.9728 -2775 6 40.7771 38.1434 21.8579 6.80518 1.6634 -4.63259 -2776 4 40.7449 39.0581 22.1203 -10.5616 15.8809 15.9679 -2777 4 41.4448 38.2055 21.1733 6.63637 -13.627 -11.1518 -2778 6 26.6799 9.85647 27.3982 -25.6987 30.8747 18.2417 -2779 4 27.0738 9.12687 26.9584 7.64189 -30.2216 -11.3166 -2780 4 25.7862 9.62595 27.7363 13.5029 -2.01996 -6.34848 -2781 6 53.4177 39.431 11.7682 60.4327 6.90374 -14.3662 -2782 4 54.4363 39.4906 11.5459 -51.7213 -2.15349 13.0324 -2783 4 53.0514 40.2823 11.4531 3.65586 -10.6921 6.91198 -2784 6 35.3318 21.4177 2.24537 5.41769 -12.1321 -20.1082 -2785 4 34.8431 20.6225 2.51379 1.47903 7.83344 1.83382 -2786 4 35.7036 21.1864 1.3528 -11.9529 6.47568 24.5243 -2787 6 4.13637 17.136 33.9211 3.37621 -12.3766 5.67686 -2788 4 4.20441 16.396 34.5697 -7.88327 11.3141 -11.775 -2789 4 3.23668 17.1493 33.5445 4.32036 -6.23827 5.33579 -2790 6 24.1551 16.173 14.6595 0.905264 -13.203 -15.7913 -2791 4 24.2344 17.0724 14.9677 3.21898 8.1818 3.14137 -2792 4 23.7074 16.2777 13.8038 1.81958 -4.41422 2.08172 -2793 6 43.135 2.84466 26.1032 13.1229 6.35408 -5.68313 -2794 4 42.2875 3.17639 26.414 -4.49653 4.08553 -4.30298 -2795 4 43.2684 3.17059 25.1875 -5.24638 -3.17663 12.7173 -2796 6 40.6938 12.184 1.56501 -11.5288 -7.07153 -25.6549 -2797 4 41.6237 12.1687 1.8186 -0.151998 5.09311 17.9246 -2798 4 40.0653 12.4844 2.24465 11.7671 0.703669 4.7582 -2799 6 47.3771 8.09383 26.755 61.1653 27.2124 16.0462 -2800 4 46.6352 7.69428 26.3774 -33.8593 -24.2939 -29.8281 -2801 4 48.1554 8.02079 26.1437 -24.5213 -4.41693 14.2109 -2802 6 35.8722 30.7298 38.4929 46.7797 8.20249 -0.795626 -2803 4 35.8437 29.9971 39.0885 -23.8052 -20.0767 8.1402 -2804 4 36.8495 30.8926 38.5637 -31.083 11.8011 -18.5205 -2805 6 51.2951 23.2205 32.4921 -21.4102 17.5258 -2.96787 -2806 4 51.6315 24.0445 32.1105 -0.705735 5.94923 -0.836877 -2807 4 52.0737 22.714 32.6486 16.7198 -16.4886 4.04233 -2808 6 30.6141 4.4461 39.6711 -15.3731 3.79473 -35.0115 -2809 4 30.9464 3.61986 40.0176 9.77962 -4.83986 19.2734 -2810 4 30.7704 5.18568 40.2576 9.11216 5.26318 14.244 -2811 6 35.2646 29.7051 2.85778 -14.8887 -12.395 -20.7058 -2812 4 35.7986 29.7272 2.02588 -11.2321 -1.99949 14.2373 -2813 4 34.4405 29.1492 2.64359 32.9241 21.0754 6.44042 -2814 6 50.3111 26.1454 9.40098 -22.1621 10.9454 -20.0185 -2815 4 49.986 26.7793 8.71172 15.2241 -16.6208 13.1315 -2816 4 49.7063 25.388 9.31525 11.793 4.08785 3.97386 -2817 6 50.0869 36.8245 26.4088 -20.9012 -6.38176 7.71076 -2818 4 49.5586 36.0705 26.7514 3.9746 5.79943 -8.74909 -2819 4 50.1941 37.3864 27.1871 4.41306 8.36789 0.548966 -2820 6 40.3119 23.9565 38.5384 47.4279 -1.39254 -15.5521 -2821 4 40.88 24.732 38.748 -21.3925 -13.0784 -2.40019 -2822 4 39.4343 24.1145 38.8527 -20.1214 13.5622 11.7594 -2823 6 24.9444 10.7496 30.6663 31.051 18.5451 27.0394 -2824 4 25.7305 10.8456 31.2787 -28.4 -7.1047 -26.2292 -2825 4 24.8995 11.6269 30.2371 -7.15612 -14.1049 -2.61146 -2826 6 5.89131 1.01728 5.39947 -5.16247 -17.9253 -0.227043 -2827 4 5.22088 0.340863 5.59281 2.49468 7.88844 1.50452 -2828 4 6.71299 0.544267 5.57411 4.99832 4.76302 -4.28882 -2829 6 44.2927 29.3807 26.2764 43.728 -18.4205 -0.18667 -2830 4 43.5018 29.5461 25.816 -39.4067 7.83222 -12.62 -2831 4 44.7851 28.7616 25.699 -3.50466 6.32584 16.51 -2832 6 25.3064 10.1814 6.6654 -6.94402 -15.718 -9.61204 -2833 4 25.6542 11.0594 6.61048 6.10034 18.8978 1.37462 -2834 4 25.5624 9.77067 5.8255 0.943829 -2.29537 1.40094 -2835 6 13.3606 28.0664 2.58456 21.0736 -2.27515 1.79417 -2836 4 12.4645 27.8304 2.42125 -25.9451 -0.745297 2.44011 -2837 4 13.7867 27.7237 1.79619 10.8353 3.06046 3.23802 -2838 6 6.45257 40.24 18.0133 20.0379 8.33657 1.98834 -2839 4 6.89988 39.3931 17.8777 -5.14522 -3.62214 0.392952 -2840 4 5.56311 40.1207 17.6969 -15.0406 -3.82351 -6.06839 -2841 6 47.8011 13.5056 2.01844 -10.5648 -21.267 23.3214 -2842 4 48.1524 12.6081 2.17165 -2.87721 6.43796 -2.24674 -2843 4 48.4275 13.9546 1.48105 20.9852 11.6376 -18.273 -2844 6 13.5939 20.3067 2.43603 17.8956 14.689 14.157 -2845 4 13.8339 19.6256 3.09172 -4.40777 3.66463 -6.9739 -2846 4 12.9598 19.9059 1.86118 -14.8369 -10.3601 -11.305 -2847 6 15.2334 0.8368 36.6591 1.55142 7.70692 -22.3998 -2848 4 15.2542 1.38367 37.4773 0.960764 -3.32816 -20.1037 -2849 4 15.3344 1.45306 35.8608 -4.23652 -17.7771 37.8382 -2850 6 33.6147 35.2459 15.1 16.7734 -11.8793 -18.4599 -2851 4 33.8163 35.2873 16.0538 13.2499 -3.34836 -12.9991 -2852 4 34.4154 34.9808 14.5294 -23.6504 9.8312 34.8639 -2853 6 21.8005 9.23588 0.431159 13.8262 -19.7524 30.0596 -2854 4 22.4067 9.05801 41.6249 5.27322 -0.932182 -12.5411 -2855 4 21.1072 9.74412 0.0564903 -22.836 18.1195 -16.0408 -2856 6 38.1565 27.4627 3.04439 18.4183 -28.2807 7.84104 -2857 4 37.7322 27.3164 2.21113 -4.60599 -14.2952 -24.3043 -2858 4 37.7632 28.2451 3.34335 -13.6136 36.2365 19.5187 -2859 6 38.8873 27.196 11.7739 15.5044 -8.33717 -5.93911 -2860 4 38.7841 26.3327 12.232 6.37868 6.61944 -11.5261 -2861 4 39.5786 27.1133 11.0659 -17.5863 -8.28826 19.2684 -2862 6 29.8757 41.5959 28.7066 13.5858 28.49 -11.3766 -2863 4 28.9647 41.3014 28.7466 -9.40406 -2.02578 1.88502 -2864 4 29.8997 0.254331 27.9025 -2.68961 -11.7418 13.302 -2865 6 34.0266 8.72323 38.0698 33.719 9.40995 4.6971 -2866 4 34.8877 8.24089 38.094 -11.378 13.1352 -1.62724 -2867 4 33.3712 8.08689 37.8245 -20.4874 -15.945 -8.86187 -2868 6 38.8142 27.3472 30.6886 -7.48306 -22.0573 -0.58069 -2869 4 38.4096 26.5151 30.3537 9.19692 16.3236 1.53567 -2870 4 38.2655 27.5885 31.4334 -4.0026 6.56393 5.14207 -2871 6 41.6513 17.2644 36.3568 8.49285 18.5772 4.12306 -2872 4 41.236 17.1887 35.5016 -7.55839 -3.54967 -10.3568 -2873 4 41.7813 16.3888 36.7033 1.22956 -17.0266 1.65102 -2874 6 30.7157 26.9788 35.2038 -10.151 -4.28381 0.0670681 -2875 4 31.4488 27.4236 34.7965 20.0965 0.384289 -13.2747 -2876 4 30.343 27.6484 35.7639 -8.80839 6.96039 12.3672 -2877 6 47.5342 4.10778 27.2888 11.6095 8.93875 26.3727 -2878 4 46.6105 4.27591 27.501 -8.38331 -0.425724 -4.8003 -2879 4 47.5988 3.99389 26.3497 -6.2541 -0.220522 -17.1995 -2880 6 20.9412 8.38521 7.26575 -18.1268 -17.2637 2.68033 -2881 4 20.8809 8.87169 8.08328 -6.592 1.96128 21.9757 -2882 4 21.4179 8.98778 6.73029 19.5174 18.1449 -30.7672 -2883 6 36.8608 13.6781 0.872276 -22.567 18.0135 -7.8322 -2884 4 37.3857 13.5342 1.64823 18.2236 -14.2068 17.6988 -2885 4 36.9649 12.9376 0.269125 7.56106 -9.0363 2.17502 -2886 6 28.5805 20.3012 26.4498 13.4935 0.222411 -13.7489 -2887 4 28.4835 19.3803 26.2016 0.90122 -3.21423 2.30104 -2888 4 27.7964 20.5416 26.9224 -18.5183 5.12398 12.3317 -2889 6 51.6021 16.8515 33.5179 -11.2544 -15.3 0.627003 -2890 4 51.563 16.0241 34.0301 0.916298 4.09207 -0.753195 -2891 4 51.0058 16.6639 32.7753 6.31462 4.20327 -0.345536 -2892 6 16.2626 32.019 37.6812 -31.2107 -29.2496 -22.9287 -2893 4 16.4537 31.3803 38.4011 -2.23747 12.829 -12.3594 -2894 4 15.5373 31.5705 37.1079 31.9743 21.1891 23.5065 -2895 6 14.3366 25.8859 13.2055 -16.2598 35.1345 -7.65407 -2896 4 13.5591 26.1022 13.7538 4.79106 -9.45955 4.66587 -2897 4 14.3924 26.7004 12.6499 8.67511 -16.0651 4.90492 -2898 6 54.9632 28.863 3.30225 1.80665 -46.0259 4.02989 -2899 4 54.8334 28.8705 2.33571 2.30679 -1.29159 7.0988 -2900 4 0.250446 27.9134 3.53944 -11.9885 37.0888 -10.0107 -2901 6 17.2065 5.13222 2.58226 -24.5489 -19.7693 -14.9516 -2902 4 17.8239 4.45011 2.8785 5.4716 1.45995 5.40018 -2903 4 17.4096 5.93537 3.0482 10.2082 3.99522 6.08435 -2904 6 50.7076 33.0524 10.3335 3.48719 10.0002 9.95533 -2905 4 50.6136 33.804 9.75033 0.0726689 14.8217 2.89741 -2906 4 50.6632 32.3255 9.72979 -1.7797 -23.5385 -6.20373 -2907 6 28.8719 19.8379 32.3662 12.2168 9.43689 -9.94144 -2908 4 29.8293 20.0527 32.223 -26.7315 -2.75674 4.09206 -2909 4 28.3919 20.677 32.2058 6.96369 -8.55206 2.54368 -2910 6 22.4258 12.8301 23.3099 -21.9068 12.8519 23.6974 -2911 4 22.5424 12.4187 24.2055 -3.2327 9.70973 -17.8182 -2912 4 21.6904 13.4906 23.4219 18.0295 -16.5223 -3.23075 -2913 6 54.7859 15.5473 8.87871 3.42684 8.57095 -7.37477 -2914 4 0.5152 15.244 9.45304 -3.41058 -4.28924 6.32649 -2915 4 53.9742 15.1056 9.16818 6.16615 -2.4265 3.01646 -2916 6 10.455 19.2982 26.169 33.281 -8.93788 40.2277 -2917 4 11.227 18.6906 26.1605 -15.5014 12.2348 -4.03004 -2918 4 10.0694 19.2521 25.3251 -19.4777 -1.76614 -41.28 -2919 6 38.6541 20.3016 35.2246 25.1317 -2.89776 0.584273 -2920 4 39.6122 20.389 35.0245 -16.8563 1.20482 1.7302 -2921 4 38.6037 19.6498 35.9401 -3.42784 5.37932 -3.92632 -2922 6 17.4847 18.0451 15.2473 -2.11698 43.6037 15.5575 -2923 4 17.3165 17.6253 14.4157 -4.81229 -12.7227 -25.2707 -2924 4 17.3243 19.0143 15.0283 6.45297 -29.0578 8.37137 -2925 6 29.6412 0.96029 26.2538 -2.92598 -32.1867 -14.968 -2926 4 29.2295 1.80722 25.9783 -5.05853 -19.2177 -5.0061 -2927 4 29.2302 0.136786 25.7855 11.2507 47.838 14.1271 -2928 6 30.4583 12.6781 28.2933 9.80318 -11.3268 12.128 -2929 4 29.9046 13.1756 27.6811 -9.35495 -4.05719 -6.55314 -2930 4 30.1425 11.7563 28.3949 -4.92949 12.905 -7.65094 -2931 6 36.6582 22.1039 33.3564 18.5548 3.44171 -30.7077 -2932 4 37.613 21.8793 33.4826 -21.695 5.78572 4.26475 -2933 4 36.1698 21.8632 34.1249 -2.38139 -6.6943 29.4942 -2934 6 34.851 22.4634 14.295 34.3706 -12.4795 -36.6647 -2935 4 34.1306 22.5878 14.8998 -26.9044 -0.864951 1.69223 -2936 4 34.6097 22.0485 13.4154 -10.7342 10.9778 31.0087 -2937 6 15.5278 9.60588 7.43972 42.9889 -30.8008 -13.2318 -2938 4 16.5289 9.52064 7.17624 -51.4641 3.68278 11.9177 -2939 4 15.1523 8.68078 7.51431 10.3517 24.0811 1.24627 -2940 6 21.8097 28.0449 19.8036 -9.3837 2.2861 -3.69714 -2941 4 21.8234 28.4749 20.6579 1.49564 5.45585 8.79124 -2942 4 20.892 27.7474 19.715 3.3935 -2.50466 0.747966 -2943 6 34.5377 24.4067 2.43307 17.6783 -35.0943 7.08511 -2944 4 34.5604 23.3833 2.29911 9.6022 45.0517 12.0591 -2945 4 35.2671 24.6922 3.07368 -22.5652 -15.0324 -19.8681 -2946 6 12.5974 20.9324 33.5156 -46.2472 -18.3539 -4.34371 -2947 4 11.7028 20.621 33.8238 24.9199 8.0821 6.3307 -2948 4 12.4411 20.8933 32.5604 17.1824 5.4367 5.76912 -2949 6 45.7726 31.1546 8.70236 -14.9606 25.5026 -0.599968 -2950 4 45.9029 32.1319 8.75243 4.68257 -18.3747 -3.63409 -2951 4 44.8252 31.0158 8.86685 6.58294 -2.27884 -1.49072 -2952 6 15.4856 22.546 30.183 -27.3843 -7.95278 -8.87715 -2953 4 16.2041 23.1276 30.4314 15.0704 -4.03687 4.09321 -2954 4 15.7065 21.6006 30.174 10.2057 11.8959 3.83923 -2955 6 39.7496 17.1848 38.4183 10.7213 7.86871 6.49434 -2956 4 39.4778 16.5926 37.6964 5.17631 5.73732 3.80123 -2957 4 40.5328 17.6892 38.1152 -12.3514 -12.5856 -1.70264 -2958 6 14.0114 24.6894 0.67727 2.36324 3.45559 -2.63023 -2959 4 14.2236 24.5974 1.61702 0.728832 5.12592 -0.706901 -2960 4 14.3876 25.5307 0.374588 3.08684 -2.75846 6.71077 -2961 6 31.517 19.5744 3.57234 -39.7066 16.7987 -9.47084 -2962 4 30.9812 19.3042 4.35775 22.6375 1.42354 -10.5596 -2963 4 32.4299 19.3292 3.64982 19.3858 -12.3464 7.87151 -2964 6 36.0836 25.0594 19.4567 -36.7914 6.39304 28.0525 -2965 4 37.0156 25.1955 19.4145 23.7106 3.97855 -3.98164 -2966 4 35.8434 24.7134 18.6052 0.797557 -6.28507 -17.3783 -2967 6 51.6689 17.6827 14.8094 17.1445 12.5774 26.8045 -2968 4 51.9037 18.5572 15.2299 -9.72171 -22.1194 -12.5657 -2969 4 51.1779 17.9239 14.0295 -8.26923 9.08158 -15.405 -2970 6 37.7112 27.5006 38.1887 12.9616 35.4771 9.449 -2971 4 37.6633 26.7956 37.5532 1.11487 -12.4995 -15.1422 -2972 4 38.1924 28.2458 37.7567 -11.1334 -22.4905 3.32353 -2973 6 34.7974 13.8528 30.7792 38.2139 14.8122 -13.8353 -2974 4 35.0479 14.6237 31.2931 10.1718 6.91547 -1.09557 -2975 4 34.0108 13.6012 31.1887 -47.9834 -23.6229 17.9792 -2976 6 19.6227 37.378 39.9679 -4.73731 -6.94245 -18.3615 -2977 4 20.5687 37.4692 40.1123 7.88808 5.09103 7.87528 -2978 4 19.5641 36.8976 39.1176 -6.21843 3.50671 7.67834 -2979 6 40.9479 34.0678 21.4433 -0.249567 -14.1225 -18.8789 -2980 4 41.1016 33.9428 22.3797 -2.14769 -1.67588 5.36328 -2981 4 40.6839 33.1793 21.1286 -1.36491 12.9737 -0.808456 -2982 6 32.9563 27.2052 26.5619 16.765 25.3633 38.6423 -2983 4 33.6584 27.782 27.0193 -28.2502 -21.1678 -18.3317 -2984 4 33.3196 26.985 25.7164 10.2198 -2.00428 -21.725 -2985 6 24.4119 18.6722 15.6191 2.60565 2.56356 0.790403 -2986 4 23.5591 19.1036 15.7005 -5.06369 4.62453 -0.705819 -2987 4 24.5532 18.2558 16.4735 3.02917 -4.75652 8.16225 -2988 6 29.9677 1.63803 9.07283 -8.6377 39.5876 -9.34009 -2989 4 30.0634 0.720354 9.20948 2.18912 -36.9171 5.61628 -2990 4 29.1461 1.70687 8.54641 9.48634 -0.985828 6.78106 -2991 6 31.4838 20.0989 7.86304 35.53 0.0326438 -30.7549 -2992 4 32.0429 19.6076 7.17649 -26.3889 9.76992 30.1887 -2993 4 30.8408 19.4752 8.19414 -7.49558 -12.7978 -1.24617 -2994 6 35.0504 3.77818 33.2765 0.0823497 -0.922868 12.9261 -2995 4 34.3448 4.25588 32.7981 8.7563 -3.59111 2.91721 -2996 4 34.8655 3.9194 34.2319 -2.64551 -3.11561 -17.2257 -2997 6 43.9652 7.96842 12.9746 -1.99776 -12.8019 0.966431 -2998 4 43.3695 7.30717 13.3748 13.3395 3.08022 -2.86187 -2999 4 43.3917 8.71398 12.8108 -3.39849 12.2944 -1.42541 -3000 6 44.1076 32.6848 16.9531 4.83347 14.0385 -4.8226 -3001 4 44.7886 33.3699 16.7553 -9.08835 -13.3706 7.91806 -3002 4 44.1269 32.547 17.9059 1.63547 3.97279 4.50154 -3003 6 40.604 27.1617 19.037 5.49217 0.683783 -24.0967 -3004 4 39.907 26.5243 18.7614 10.7357 10.4426 0.818988 -3005 4 41.0572 27.5561 18.2306 -16.7517 -14.1941 23.9583 -3006 6 46.0503 23.2068 29.0603 33.2935 27.7725 23.492 -3007 4 46.7239 23.8517 29.4252 -26.0483 -15.0892 -12.6312 -3008 4 46.5249 22.3737 28.9794 -1.25341 -9.22801 -2.13192 -3009 6 42.6264 30.606 18.8462 -34.271 -0.881878 -8.8004 -3010 4 43.5242 30.7893 19.1074 18.3218 -5.88078 -5.57768 -3011 4 42.5428 29.9264 18.1492 10.4183 2.57162 5.03187 -3012 6 36.1231 10.8975 23.2614 14.248 33.6052 6.96597 -3013 4 35.2264 11.248 23.1278 1.11349 -2.62395 -2.03304 -3014 4 36.6438 11.7125 23.5215 -18.5882 -27.5405 -10.5609 -3015 6 13.7387 31.5187 15.7175 -8.63655 -3.85126 -4.64142 -3016 4 14.6788 31.7096 15.8046 0.813603 4.25462 -2.48371 -3017 4 13.3439 32.0503 15.0041 7.14664 -1.81478 4.34843 -3018 6 33.1663 41.4263 27.7844 10.1514 -8.73892 50.1834 -3019 4 33.0558 0.0915148 27.0508 0.335607 20.6114 -25.4934 -3020 4 33.386 0.0476391 28.6 -4.59167 -12.6797 -24.4066 -3021 6 32.8924 22.9248 31.4777 14.8331 -14.2772 -3.0724 -3022 4 32.331 22.9976 30.6823 -4.11553 14.0534 8.76104 -3023 4 32.7731 23.648 32.1168 -12.639 5.72297 -14.9522 -3024 6 27.6514 16.8629 6.392 5.9792 -3.02818 28.7598 -3025 4 27.8554 17.3015 5.57876 -0.492343 9.99532 -20.1105 -3026 4 26.7867 16.4634 6.29535 -11.4685 -3.6273 -5.68351 -3027 6 47.2692 11.6326 26.0701 -7.51592 -12.561 -4.95541 -3028 4 47.0451 11.5188 27.0189 12.1951 16.3083 -15.426 -3029 4 47.7234 12.4489 25.7723 -5.45211 -2.19527 19.0308 -3030 6 27.5533 7.05227 7.64253 19.1893 -9.34804 28.5196 -3031 4 26.7486 7.45205 7.94122 -22.9318 8.15137 -1.85106 -3032 4 28.0959 7.04706 8.46187 -1.51515 -0.839126 -23.0353 -3033 6 39.7861 9.0687 11.9758 -15.1444 6.22431 -7.98147 -3034 4 39.495 9.25597 11.0599 4.77492 -2.72739 13.3066 -3035 4 38.9879 9.23938 12.5098 3.46881 -0.389139 -2.20355 -3036 6 18.1894 33.4728 36.1008 -27.5283 -9.1571 7.06889 -3037 4 17.6722 33.9726 35.425 4.94426 -9.47891 13.9641 -3038 4 17.5468 32.9442 36.6812 19.6546 19.0371 -24.2711 -3039 6 37.1945 26.5569 0.720807 -12.4444 8.19753 -2.53971 -3040 4 37.3568 25.6462 0.476597 4.7119 -6.04631 0.679389 -3041 4 36.2336 26.6328 0.585525 8.76389 3.8419 -0.879611 -3042 6 44.2004 19.6233 36.8917 26.7932 -13.3754 0.0595121 -3043 4 45.0387 19.0956 36.766 -19.227 18.7818 5.02367 -3044 4 44.4376 20.5683 36.9644 1.27086 -9.01627 -1.91077 -3045 6 27.7799 6.35317 35.6882 16.2858 -3.70231 1.18314 -3046 4 27.1634 6.96571 35.2926 -9.46908 3.45363 -4.90602 -3047 4 27.3042 5.53742 35.858 -2.00694 0.00942349 2.38052 -3048 6 34.7653 16.4924 20.8795 20.4023 -19.0949 10.3746 -3049 4 35.5516 15.8729 20.9898 -30.5098 25.2475 -4.70775 -3050 4 34.1298 16.2162 21.5757 7.90375 5.70636 -13.0995 -3051 6 39.0303 20.9673 40.4307 -20.4786 -67.2325 12.8224 -3052 4 38.8254 20.089 40.9106 11.5443 40.6977 -30.184 -3053 4 39.2642 21.5386 41.1412 8.11615 27.562 18.514 -3054 6 10.8068 27.9205 1.65866 27.4379 7.91142 -24.506 -3055 4 10.0967 27.7204 2.22826 -30.9372 -12.069 25.0324 -3056 4 10.8782 28.8813 1.73209 2.10338 1.16742 -2.23752 -3057 6 47.025 23.1272 13.2603 -26.8307 -11.5375 0.419605 -3058 4 47.6563 23.6094 12.7175 1.22463 1.60122 -3.88323 -3059 4 46.2701 22.846 12.6737 25.4538 5.98786 18.4886 -3060 6 34.5769 28.3999 10.6617 -26.3731 9.09486 -11.6064 -3061 4 34.5145 27.7223 11.3448 13.7244 -2.44185 1.37306 -3062 4 35.5023 28.5375 10.4336 6.33869 -4.76798 1.2135 -3063 6 3.33738 17.579 14.2816 -4.12164 13.1786 -2.02309 -3064 4 3.51487 16.7052 14.5979 -0.480238 -24.8864 6.17379 -3065 4 3.96197 18.0965 14.8055 -3.35437 6.17503 -1.46632 -3066 6 27.7248 11.5976 7.52038 4.0705 34.1711 4.34085 -3067 4 27.7194 12.5939 7.6487 2.26317 -33.1326 -4.66749 -3068 4 27.2616 11.2314 8.28138 -1.22149 -2.70865 2.4378 -3069 6 41.4317 28.339 9.02961 12.1835 18.6619 -21.5911 -3070 4 40.932 28.9387 9.57928 -8.65956 3.59764 13.3257 -3071 4 41.6711 28.9179 8.26221 -0.754142 -18.9314 12.3863 -3072 6 42.0732 4.78493 8.18399 0.592074 10.501 -23.0953 -3073 4 42.2656 5.73441 7.90258 -4.03181 -32.5079 3.94615 -3074 4 41.9391 4.19656 7.39311 5.50228 24.8072 19.85 -3075 6 28.4553 8.6408 40.3288 -1.1592 2.81238 -0.593175 -3076 4 27.8014 8.47839 41.05 3.29603 2.13238 -25.5829 -3077 4 28.0374 8.68456 39.4248 -2.58083 -3.24862 30.0681 -3078 6 0.723272 18.248 15.2854 4.61761 3.31073 11.0333 -3079 4 1.58056 18.1517 14.8782 17.0637 -0.561901 -5.4503 -3080 4 0.169553 17.7112 14.727 -13.9143 -7.94922 -7.42873 -3081 6 7.11829 16.2161 40.455 0.573222 -5.60735 -16.9123 -3082 4 7.21814 15.2583 40.7035 1.10072 25.2259 14.7352 -3083 4 7.17549 16.8833 41.1741 1.82325 -21.1089 2.38217 -3084 6 41.0856 8.6232 20.9154 1.44565 10.3804 -0.748136 -3085 4 40.3857 8.53297 20.2693 -12.0873 -13.8416 -3.91841 -3086 4 41.3541 9.53003 20.731 8.87844 6.62655 8.68036 -3087 6 31.7065 7.41805 37.5384 1.8504 0.880847 10.656 -3088 4 31.4927 7.12037 36.644 -5.569 -4.06437 0.235955 -3089 4 30.9766 7.14703 38.1182 6.88034 1.43502 -8.9471 -3090 6 40.7175 11.6353 25.4105 -5.83472 20.1078 -6.29096 -3091 4 40.8441 12.5768 25.6218 -9.59803 -8.51017 -7.38463 -3092 4 41.5254 11.2592 25.7328 13.3582 -17.7026 5.353 -3093 6 29.8893 30.1615 6.66958 6.45784 -4.04896 -4.41327 -3094 4 30.5285 30.6751 6.15191 0.92206 -5.81994 -1.29615 -3095 4 30.2313 29.249 6.64761 -0.535397 8.70224 -1.24193 -3096 6 40.83 24.591 5.67679 17.1105 23.9162 -4.99229 -3097 4 41.4401 25.3556 5.89599 -18.0089 -21.1831 -4.73113 -3098 4 40.1352 24.5742 6.32932 -4.29697 2.2625 8.62223 -3099 6 34.3954 9.09122 20.4203 -0.702674 2.95809 7.47625 -3100 4 33.5897 9.50113 20.7506 -0.63314 5.38769 7.97821 -3101 4 34.107 8.76785 19.5728 -0.194313 -9.82044 -16.4611 -3102 6 18.2164 33.5433 26.5438 32.3972 -29.6611 -30.5808 -3103 4 19.1929 33.4142 26.4527 -23.3283 -2.37285 -6.48837 -3104 4 18.1915 34.0681 27.3044 -13.0981 29.1765 42.7321 -3105 6 28.9207 17.4075 26.7926 -1.66434 -4.11711 9.90999 -3106 4 28.2497 17.0259 26.21 0.151798 0.605301 -3.15085 -3107 4 28.4243 17.7127 27.5796 8.50802 -3.38176 -8.48604 -3108 6 50.4389 35.5612 18.195 -0.220837 -24.3132 -9.08897 -3109 4 50.4331 35.2145 17.2813 -0.853004 14.3463 8.17747 -3110 4 50.3692 34.7248 18.6968 -4.07606 17.1918 3.62275 -3111 6 2.99582 21.5586 31.4575 0.708202 -18.646 -28.6731 -3112 4 3.24926 22.2892 30.8424 -5.67023 -11.8068 12.1364 -3113 4 2.8516 20.7624 30.8616 4.12476 24.3831 20.6408 -3114 6 36.1857 18.7483 8.60511 9.96184 26.1081 -2.68835 -3115 4 36.1356 17.8778 8.93402 3.95956 -36.7917 21.724 -3116 4 35.6171 18.7388 7.85438 -14.2398 9.24248 -24.4438 -3117 6 20.2742 6.47995 33.7286 -0.427153 4.78104 -4.08195 -3118 4 19.8935 6.35632 34.6244 -2.14212 -11.6635 -12.611 -3119 4 20.0876 5.70362 33.1559 -1.45185 1.76636 16.8362 -3120 6 13.9952 30.5211 6.65468 -0.834568 0.374695 7.89925 -3121 4 14.6781 31.0539 7.1149 -10.4447 -7.07426 -7.17019 -3122 4 13.1432 30.7212 7.07951 7.79461 1.02333 -2.73826 -3123 6 36.2732 16.4484 35.7639 18.345 14.0335 0.961522 -3124 4 37.2268 16.2475 35.9495 -24.6333 8.21497 -3.5549 -3125 4 36.1837 17.4253 35.5797 7.74798 -29.1845 4.36862 -3126 6 45.8208 37.6575 9.69399 14.3507 -31.8621 -27.6249 -3127 4 45.4608 38.3019 10.268 -8.06385 16.394 26.7739 -3128 4 46.3975 37.0305 10.1733 -1.81999 10.6315 0.898341 -3129 6 47.4165 17.984 27.6369 4.10759 -46.3966 -5.45297 -3130 4 47.5682 17.4629 26.7823 -7.01073 17.4072 30.8444 -3131 4 47.4562 17.3293 28.4007 0.542452 20.9274 -25.5144 -3132 6 25.9608 18.2932 0.952258 -4.39486 21.5955 18.9376 -3133 4 26.1989 18.9101 1.66086 12.5057 -8.35286 -7.15646 -3134 4 25.0082 18.3237 1.04468 -12.1408 -13.2893 -13.6751 -3135 6 27.3648 22.4066 4.28268 2.26175 -24.9034 0.419816 -3136 4 27.3706 23.3409 4.46802 1.80952 16.8807 -5.51915 -3137 4 27.3027 22.2785 3.32806 -2.77408 5.10873 4.5687 -3138 6 3.39125 3.84856 27.607 3.69966 -10.1033 0.490887 -3139 4 4.0137 4.55908 27.5406 6.78149 24.6072 0.911673 -3140 4 3.97847 3.09168 27.5281 -8.4044 -12.3732 0.103181 -3141 6 45.3633 27.6554 28.8452 2.12727 -1.25659 10.7713 -3142 4 44.5282 27.2015 28.6866 -4.83999 -4.58212 3.48715 -3143 4 45.3811 28.2979 28.14 4.63148 6.41932 -6.37453 -3144 6 28.4005 32.3772 16.2203 23.7034 -3.75626 0.763822 -3145 4 29.2297 32.2225 15.6968 -18.0553 4.16843 14.9752 -3146 4 28.6795 32.6874 17.1033 -0.325788 -1.29005 -11.6373 -3147 6 9.90477 33.835 13.0292 3.70295 -3.7397 30.9684 -3148 4 9.58558 33.3049 13.7992 6.56164 12.5415 -12.6178 -3149 4 9.32425 33.6546 12.2978 -12.2649 -3.83445 -16.8068 -3150 6 38.3301 26.6316 14.917 8.16845 -9.374 -1.40965 -3151 4 38.7482 25.7736 15.154 -10.3234 14.7528 -2.05039 -3152 4 37.3847 26.6122 15.1206 3.66029 -5.29 2.35016 -3153 6 31.3553 16.3729 4.24558 -11.5598 -13.3523 13.2112 -3154 4 30.5395 15.8971 4.54084 13.4071 7.11555 -7.19651 -3155 4 31.205 16.607 3.32285 -2.62497 2.93757 -4.30077 -3156 6 6.17611 3.41063 6.5613 17.7272 3.64487 37.5473 -3157 4 6.46982 3.08663 7.46094 -9.0795 17.2981 -27.883 -3158 4 6.02642 2.6045 6.08389 -2.81663 -13.5692 -12.3872 -3159 6 42.5919 12.9938 5.62253 0.302259 -11.3067 -0.460125 -3160 4 42.3001 13.8766 5.84478 4.87778 6.39543 1.2284 -3161 4 43.5084 12.9049 5.92305 -2.35353 0.46184 -1.33783 -3162 6 41.0467 31.3953 33.7949 3.79599 37.3117 5.16998 -3163 4 40.7289 31.3961 34.7173 5.05156 -5.30154 -15.2916 -3164 4 41.2174 32.3636 33.5809 -4.47671 -37.1445 4.47908 -3165 6 52.8595 12.0576 26.2617 4.7779 -12.5882 -49.4794 -3166 4 52.3971 12.713 26.7564 -13.8804 18.303 15.9364 -3167 4 52.6839 12.2865 25.2977 8.87889 -9.64762 29.5111 -3168 6 39.2197 4.29237 29.0569 11.235 6.95972 3.08537 -3169 4 38.4782 4.84799 29.3396 4.36118 -6.50894 -4.0878 -3170 4 39.9967 4.59393 29.5615 -4.77927 -7.36273 -4.89832 -3171 6 3.64414 27.0065 11.2815 -12.9441 10.9516 -6.43872 -3172 4 4.59106 26.8908 11.2849 14.3058 -9.72403 4.26042 -3173 4 3.53535 27.8319 10.7781 -8.82957 -2.80904 -0.131447 -3174 6 41.5421 29.6442 25.2671 -5.6293 3.19366 2.66863 -3175 4 41.8684 29.6903 24.3723 12.1179 -3.11764 -10.4285 -3176 4 40.7194 30.1326 25.2057 -6.30215 2.63585 1.74894 -3177 6 50.468 27.487 30.6705 -3.05594 -10.4468 2.57161 -3178 4 50.076 27.1594 31.5009 0.806547 4.01213 -5.24181 -3179 4 49.8217 28.0451 30.2184 -2.62753 1.96724 1.87939 -3180 6 32.7902 33.6258 41.7496 -4.87138 -4.97834 -25.0012 -3181 4 33.1641 32.7497 41.8541 3.47816 -11.5824 1.65798 -3182 4 32.8969 34.0586 0.665858 3.16614 12.7166 21.4132 -3183 6 5.9796 9.64598 7.93234 5.57207 13.1841 -10.7861 -3184 4 5.80592 9.95912 8.82583 -0.986272 -0.521215 4.5825 -3185 4 6.43021 10.3852 7.47125 -1.05258 -10.6241 3.31462 -3186 6 52.774 25.3768 27.6816 12.7732 -3.18466 28.0173 -3187 4 52.93 26.2779 28.0237 -8.60677 -10.695 -13.1321 -3188 4 53.2011 24.8527 28.4031 -8.37753 -2.27765 -26.5487 -3189 6 18.6947 23.2095 14.4724 -28.0966 8.43578 15.8218 -3190 4 18.5587 24.1605 14.7523 20.6562 -24.296 -13.1918 -3191 4 19.5669 23.0215 14.1303 11.4888 10.4676 -1.8787 -3192 6 31.2862 9.0706 13.0896 18.8649 -43.5027 -8.26415 -3193 4 31.2854 8.18164 13.5153 -0.98006 14.2242 -7.24428 -3194 4 30.8139 9.64196 13.6614 -21.2648 23.3567 24.384 -3195 6 52.8349 16.8368 29.9626 -1.04236 -5.83632 -3.7224 -3196 4 53.1314 16.3317 29.1809 4.11254 10.2245 6.81583 -3197 4 53.5336 17.4658 30.2088 5.59995 -2.32318 -6.64835 -3198 6 13.48 30.6403 11.9185 -26.7 12.8254 18.6299 -3199 4 12.8874 31.2649 12.4086 6.11749 -21.3055 -11.69 -3200 4 14.2712 31.1662 11.9231 18.3999 3.72963 -5.07782 -3201 6 24.4118 24.6653 11.1776 -11.0488 -38.9105 0.0232616 -3202 4 25.2327 25.0345 11.4834 15.6111 8.28781 8.86477 -3203 4 24.5324 23.6736 11.237 -9.01076 27.817 -2.51724 -3204 6 11.1207 26.7925 5.93063 -6.41259 2.09364 -8.23675 -3205 4 11.5241 26.98 6.79711 -3.12879 8.72791 -6.17468 -3206 4 10.8719 27.6544 5.50988 6.7003 -18.2386 15.7162 -3207 6 12.0069 32.3194 4.56559 -6.93674 1.89769 -53.2748 -3208 4 11.7104 31.8608 3.68045 16.1117 25.2499 46.2442 -3209 4 12.3686 33.2222 4.3326 -9.20365 -26.1492 2.14142 -3210 6 6.43611 5.48582 30.4705 10.9412 7.27018 -5.81208 -3211 4 6.8324 6.31983 30.1884 15.302 -0.761667 0.276275 -3212 4 5.5204 5.70213 30.4126 -22.6187 -2.98333 3.5448 -3213 6 38.1723 39.6045 29.3805 -11.1368 -0.968084 -7.99101 -3214 4 37.5332 40.3179 29.1036 12.1085 -24.1545 -0.917311 -3215 4 37.9804 38.7063 28.9788 -2.28765 36.4506 5.30967 -3216 6 52.5924 19.3736 5.41149 4.12965 0.0949992 -5.17576 -3217 4 52.3027 20.2712 5.07121 22.7239 -28.0308 -2.84369 -3218 4 53.4989 19.0543 5.10701 -28.7609 25.7225 2.66162 -3219 6 18.3561 9.81057 21.0683 -18.476 -24.6523 15.6829 -3220 4 17.6378 9.45854 20.4828 20.1245 14.4878 5.80252 -3221 4 19.033 10.2869 20.5982 6.82627 10.6552 -20.9713 -3222 6 14.5094 41.1238 15.0395 5.73538 -4.06503 -13.1796 -3223 4 15.2839 41.068 15.6075 4.55031 0.900939 7.74817 -3224 4 13.875 41.6599 15.5263 0.0235554 2.15182 4.98288 -3225 6 36.0027 23.903 26.7597 7.48895 21.6763 -35.676 -3226 4 35.8975 23.6043 27.6465 2.36908 -17.7227 17.2904 -3227 4 36.3267 23.2124 26.1374 -7.97178 4.49324 27.7844 -3228 6 35.6359 10.4157 26.2529 -13.2839 -25.1837 23.1485 -3229 4 35.969 10.5098 25.3716 5.3977 0.436992 -21.1808 -3230 4 35.4229 9.45302 26.3798 5.18698 20.1527 -7.56493 -3231 6 45.3037 24.2791 20.2723 9.06075 11.2998 -13.4968 -3232 4 45.4523 24.978 19.6109 10.2075 -1.49386 4.95329 -3233 4 44.5125 23.8555 19.9662 -13.3892 -9.58217 -2.04663 -3234 6 15.8107 39.0453 24.2393 9.7405 19.086 8.48056 -3235 4 15.3407 39.8143 24.6455 3.07287 -17.6695 -6.90152 -3236 4 16.7434 39.3626 24.1878 -22.1708 -8.11019 0.25747 -3237 6 4.61074 25.9041 16.8066 4.47487 12.325 4.32837 -3238 4 5.33363 26.3313 17.2996 -1.16871 -8.95741 -3.63592 -3239 4 3.89121 26.5439 16.91 5.27726 -3.71411 -3.28281 -3240 6 33.4791 9.99232 32.5716 -36.5508 -4.76722 -31.2046 -3241 4 34.3147 10.2419 32.89 39.2476 10.968 21.6954 -3242 4 33.0188 9.57531 33.3002 0.324125 -5.12222 10.2577 -3243 6 22.9388 37.5185 1.51191 -4.27166 -24.2064 8.31852 -3244 4 23.0334 38.2273 2.154 1.20614 3.86272 6.71724 -3245 4 22.69 36.6978 2.02191 6.96614 23.4315 -10.5782 -3246 6 39.1324 20.5485 25.4772 25.265 -11.778 19.9951 -3247 4 39.2103 21.4279 25.1215 -1.526 12.0473 -3.88318 -3248 4 39.8813 20.4818 26.1301 -17.748 -0.0581828 -14.4699 -3249 6 25.0622 25.0762 37.6014 21.4558 5.76047 -13.7935 -3250 4 26.0349 25.2337 37.6294 -19.4467 -8.38624 -4.14531 -3251 4 24.8891 24.8197 38.5048 -7.65564 -1.94532 12.2316 -3252 6 12.209 35.7591 11.4203 -9.12536 1.25056 -5.53999 -3253 4 11.4995 36.2015 10.8899 19.2305 -11.6187 8.3526 -3254 4 12.8486 35.4161 10.7797 -5.71729 7.89629 -2.43108 -3255 6 42.046 15.7235 20.1276 29.9467 5.46844 -26.2367 -3256 4 42.5818 15.5034 19.3148 -14.0105 1.75231 17.5608 -3257 4 42.3615 16.6209 20.337 -4.0808 -2.27778 2.90042 -3258 6 53.2021 25.4307 39.5282 4.69599 -13.2561 7.07883 -3259 4 53.78 25.8541 38.905 5.49131 5.5629 -6.42231 -3260 4 52.4802 26.028 39.6966 -10.1139 9.50655 0.821399 -3261 6 53.7967 21.778 1.29815 15.5744 -8.20383 1.43914 -3262 4 54.6378 21.4326 0.944441 -3.84265 -1.46767 8.18122 -3263 4 53.3536 22.1543 0.542634 -13.037 9.31425 -11.6048 -3264 6 1.93111 22.4438 20.1768 4.00387 4.12813 31.1185 -3265 4 1.5939 23.2361 20.6593 2.49828 -13.4199 -15.2591 -3266 4 2.41139 21.9607 20.8911 -6.34657 6.89732 -14.8434 -3267 6 41.1871 16.1847 11.4932 0.836017 42.0531 1.99799 -3268 4 40.9413 15.3195 11.802 -9.8633 -17.6073 7.87469 -3269 4 40.5377 16.8617 11.8588 16.4331 -27.7799 -8.96912 -3270 6 17.194 38.6096 9.61825 4.75854 -2.20459 -16.4638 -3271 4 17.8324 38.6167 10.328 10.0816 -0.610832 12.429 -3272 4 16.3385 38.6013 10.0398 -14.9506 0.593169 11.9887 -3273 6 33.2005 12.9606 38.531 8.50507 10.8774 -15.8661 -3274 4 33.6532 13.8203 38.39 -7.98235 -13.7359 5.26797 -3275 4 33.1331 12.8007 39.479 5.11874 5.24255 -4.23095 -3276 6 24.7171 21.675 39.9778 2.8762 -23.2501 -10.2076 -3277 4 24.5558 21.597 39.0096 0.45736 0.189324 11.8412 -3278 4 25.3262 20.9394 40.2143 -5.83632 9.86919 -3.30671 -3279 6 13.5803 15.5602 27.3532 26.1047 30.3564 11.1382 -3280 4 13.1676 16.145 28.014 -3.26959 -8.19558 -5.9347 -3281 4 12.973 14.8589 27.1951 -20.4184 -17.1677 1.43072 -3282 6 24.68 18.7128 9.26691 14.3839 36.3501 26.0009 -3283 4 25.3598 19.2552 8.82532 -5.31062 -15.6251 -9.27674 -3284 4 24.5166 19.2286 10.0937 -4.12977 -20.8661 -14.1648 -3285 6 10.971 8.2031 0.0820528 -5.05885 27.6393 52.7366 -3286 4 10.426 8.82187 0.676738 20.6953 -23.692 -21.2054 -3287 4 11.8511 8.19112 0.51746 -10.8092 -0.715691 -8.01276 -3288 6 15.7168 31.9426 31.3882 -16.0589 -14.8784 11.374 -3289 4 14.8784 32.0139 30.9212 -5.19427 4.39929 -5.1125 -3290 4 16.2361 32.7208 31.1626 4.51908 -4.85975 -1.07492 -3291 6 20.3853 39.1678 21.6201 3.96912 1.70678 -2.15463 -3292 4 19.8408 38.4031 21.9136 18.3946 15.2484 5.21077 -3293 4 21.1259 39.3411 22.2478 -18.5683 -14.4588 -3.61544 -3294 6 38.8575 19.5345 7.60357 -3.22682 7.2187 -10.7103 -3295 4 37.9955 19.1157 7.58645 -3.56529 1.50397 -1.646 -3296 4 39.2183 19.2349 8.43232 7.58358 -7.76078 7.45775 -3297 6 41.3566 29.7161 21.1634 -18.4754 -13.1658 17.2704 -3298 4 41.7904 29.7702 20.3348 3.95998 3.00501 -30.3792 -3299 4 42.0386 30.0045 21.7486 9.4821 7.67994 22.7786 -3300 6 50.7055 33.8359 22.0677 10.0235 -14.5617 12.8511 -3301 4 51.0634 32.983 22.4061 -4.7136 19.0099 -8.42991 -3302 4 50.4062 33.6539 21.1646 0.0172424 0.211956 1.78818 -3303 6 18.1576 11.1602 14.3564 -14.1594 -3.53412 4.86119 -3304 4 18.0624 11.3441 15.3149 3.69196 -2.83217 -14.991 -3305 4 19.1071 11.0831 14.1997 2.21718 -0.861887 0.62752 -3306 6 48.509 14.2737 15.2536 -33.8512 -15.7039 -13.3543 -3307 4 49.4102 14.4821 15.4142 31.3042 4.03673 3.1002 -3308 4 48.4635 13.5769 14.5611 0.497508 10.2707 10.4073 -3309 6 32.9892 15.7452 8.24788 15.5762 1.59093 3.47394 -3310 4 33.8184 15.532 7.78513 -5.99942 0.288096 4.45585 -3311 4 33.1922 15.7362 9.20789 -3.05234 -0.622843 -13.6288 -3312 6 42.9176 4.85532 18.7629 14.1748 1.41964 3.40057 -3313 4 42.9882 5.82921 18.9229 4.77982 -22.1758 1.39114 -3314 4 43.8043 4.45344 18.9624 -18.3785 17.0247 -7.93082 -3315 6 10.5031 23.7237 33.4382 -0.874073 19.9298 2.74355 -3316 4 10.5548 24.717 33.3795 7.7257 -28.8706 -7.54496 -3317 4 11.1379 23.281 32.8547 0.735263 11.3428 1.89897 -3318 6 1.13216 20.0583 11.2836 18.374 17.5884 12.1148 -3319 4 0.491024 19.3349 11.1994 -2.17247 3.20995 10.4498 -3320 4 1.13554 20.5377 12.169 -13.4236 -25.5013 -29.3002 -3321 6 1.52072 39.5358 14.3069 -1.86369 -19.4721 11.7014 -3322 4 0.846705 40.1803 14.5938 4.14733 -5.95668 -5.60613 -3323 4 1.29368 38.6598 14.724 6.32152 28.9753 -9.07681 -3324 6 8.31775 21.6111 14.1387 -15.017 -6.93379 31.3726 -3325 4 8.13664 21.1659 15.0266 4.22851 15.111 -30.7591 -3326 4 7.52757 21.5034 13.5919 -1.9589 1.09648 1.01763 -3327 6 7.16491 13.3069 38.2405 -3.91014 1.61314 -29.5843 -3328 4 6.63698 13.0539 37.4502 4.01765 -4.94514 23.7112 -3329 4 7.51249 14.1719 37.966 2.17516 -8.38294 10.659 -3330 6 46.6268 1.62726 18.6981 -5.20766 -2.9114 16.5849 -3331 4 47.5711 1.68468 18.9367 -9.38594 -0.162468 5.90612 -3332 4 46.1191 1.48652 19.5414 20.1897 3.23395 -16.531 -3333 6 4.07867 8.38347 14.797 30.0262 18.9917 2.43531 -3334 4 3.34187 8.3175 15.3794 -25.1937 -7.21885 10.0707 -3335 4 3.92422 7.81173 14.052 -7.87119 -13.0009 -15.9092 -3336 6 47.5843 36.535 17.848 27.4213 12.0237 5.93301 -3337 4 47.2301 35.69 17.6416 -25.9655 -28.1947 -7.00186 -3338 4 48.5203 36.321 17.8356 11.6458 7.4707 2.49139 -3339 6 48.7172 32.6081 3.62434 16.9155 19.6851 -27.3563 -3340 4 49.4676 32.1613 3.18145 -8.8052 -0.0369675 17.0972 -3341 4 48.3534 32.1141 4.33579 -5.12692 -24.8974 22.5299 -3342 6 26.8624 34.4063 15.194 -5.61502 8.38998 -0.355377 -3343 4 27.128 33.6719 15.7603 3.91671 -4.37186 -8.54489 -3344 4 27.3784 34.3384 14.3661 -3.09932 -5.4603 13.6569 -3345 6 9.98983 27.3411 13.3236 -5.30345 -60.6937 -19.0037 -3346 4 9.94192 28.2179 13.0053 -1.51785 37.2293 -13.4128 -3347 4 9.87191 26.7487 12.5139 4.66007 24.2176 27.9858 -3348 6 2.39898 26.8872 37.357 1.59401 -7.29113 19.9813 -3349 4 2.39832 26.7504 38.3162 -5.28205 -0.510768 -0.23331 -3350 4 3.33711 26.9514 37.1904 14.8183 3.44774 -11.9786 -3351 6 33.3368 17.2756 36.8005 -23.2882 7.84328 1.94786 -3352 4 32.371 17.4043 36.8526 5.24602 0.476467 11.7287 -3353 4 33.4423 17.1515 35.8622 12.5187 -3.29866 -15.2334 -3354 6 10.6624 18.8035 9.30575 -3.98781 15.2275 -14.7508 -3355 4 10.7339 18.764 8.32616 -2.59554 -5.92059 15.2764 -3356 4 10.8972 19.732 9.49452 -1.55193 -6.4517 3.37647 -3357 6 8.57833 27.4047 3.14019 -5.09403 -6.13324 -2.85576 -3358 4 8.57126 27.6547 4.08504 -2.7611 -8.03155 -6.83353 -3359 4 8.4622 26.4231 3.09919 3.19624 23.0742 12.9307 -3360 6 40.6073 33.9264 14.3399 -6.85038 20.2562 -23.9123 -3361 4 40.863 33.245 14.948 0.807967 -8.16399 15.1571 -3362 4 40.0779 34.5716 14.8204 -0.495244 -4.69725 4.10141 -3363 6 53.9925 16.7992 13.6308 6.31935 -7.9338 28.1888 -3364 4 54.0997 17.1551 12.7528 -11.031 14.1585 -18.9596 -3365 4 53.1709 17.0486 14.0912 -3.14305 7.59696 -13.573 -3366 6 39.1497 38.4912 7.40608 -39.1223 4.05884 30.5073 -3367 4 38.8859 38.5922 6.48797 -2.00378 4.08479 -3.77896 -3368 4 38.3062 38.5986 7.97667 35.5804 -2.74434 -28.8566 -3369 6 42.2129 33.6808 29.0138 -24.1371 3.42921 -11.8129 -3370 4 42.1057 34.6378 28.7577 -2.98627 -25.8941 0.854821 -3371 4 41.3475 33.1819 28.8496 28.8118 27.0492 8.45917 -3372 6 2.85866 0.0629173 20.1315 -20.2536 1.52979 -19.4947 -3373 4 2.75203 0.421025 19.2221 8.85994 -2.20895 9.93397 -3374 4 1.96017 41.6124 20.299 15.6791 2.4666 6.01858 -3375 6 24.986 26.9373 24.4454 -5.13687 18.0728 7.96565 -3376 4 25.2851 26.0172 24.3926 4.88984 -3.86206 4.04103 -3377 4 25.2923 27.4081 25.2509 0.579281 -17.4573 -11.648 -3378 6 13.6179 33.9875 7.01366 -9.87556 12.4155 -39.0476 -3379 4 14.4287 33.6264 6.65472 5.99816 -4.92128 6.68342 -3380 4 13.2096 34.3429 6.17379 4.4552 -5.00021 31.0775 -3381 6 17.6494 31.8378 3.38868 3.47258 32.8259 -24.0658 -3382 4 17.3179 32.0585 2.49435 6.00696 -1.44586 18.975 -3383 4 17.3532 30.9566 3.5196 -11.0767 -31.773 11.9025 -3384 6 31.1111 29.8483 35.9167 13.6376 7.61418 -14.6842 -3385 4 30.4141 29.611 36.5018 -19.519 -6.65958 16.6428 -3386 4 31.8988 29.4329 36.2727 4.98993 0.410401 2.8928 -3387 6 31.4643 1.69164 1.93808 20.5111 47.6543 28.2436 -3388 4 30.8038 1.05919 1.86135 -35.916 -50.7273 -13.0106 -3389 4 30.9957 2.32106 2.5233 13.9145 -2.66096 -10.7861 -3390 6 13.7147 9.36591 12.3063 -10.8769 -31.3803 3.40225 -3391 4 14.006 10.2311 12.0687 5.19854 25.7457 4.3425 -3392 4 13.2135 9.34561 13.1466 7.78847 9.513 -6.56361 -3393 6 15.2882 15.1512 12.1315 -28.7349 -8.10496 1.75886 -3394 4 14.285 15.1274 12.2085 32.3197 -4.02875 -3.81405 -3395 4 15.5527 14.5676 11.4001 -6.69875 1.91641 1.76342 -3396 6 44.9132 30.4441 13.088 -39.1187 -0.31911 18.6923 -3397 4 45.3561 30.6438 13.8967 -2.95974 2.37903 28.1101 -3398 4 45.6316 30.4633 12.5179 38.3165 -3.24606 -51.9295 -3399 6 35.1465 37.623 24.8576 -14.1582 -15.7359 28.7413 -3400 4 34.5779 38.3725 25.1706 10.6028 -16.3472 -5.82963 -3401 4 34.9593 36.856 25.4995 5.71155 29.9045 -22.7235 -3402 6 43.8948 19.2936 12.9987 -2.30513 -18.2146 13.0469 -3403 4 43.787 18.3102 12.9069 2.76315 21.1578 4.09431 -3404 4 44.375 19.4187 13.8444 -6.58761 -4.34429 -6.9628 -3405 6 14.1971 27.3925 16.8971 2.69526 11.3314 -20.1154 -3406 4 13.4533 26.7979 16.9981 -2.42546 -10.6182 5.16389 -3407 4 14.0783 27.734 15.9851 5.1255 -3.8968 13.4589 -3408 6 5.08574 37.4729 15.7377 1.34169 3.72011 38.8669 -3409 4 5.88395 37.4897 16.2981 -4.65405 2.63162 7.63907 -3410 4 5.46406 37.2335 14.9215 11.9791 -13.9554 -41.5179 -3411 6 35.4862 36.9766 33.2333 -36.83 -5.70901 2.9599 -3412 4 36.4114 37.1444 33.1615 28.5824 10.2327 4.96708 -3413 4 35.1164 37.4942 33.9725 5.15458 -1.79752 -2.84758 -3414 6 6.636 31.7097 32.9848 -22.7133 -7.33235 -24.9389 -3415 4 7.22761 30.9741 32.8206 4.14198 -5.34147 5.16294 -3416 4 6.9999 32.2337 33.6789 14.5784 9.31919 13.8511 -3417 6 31.283 20.2175 25.4647 -9.91499 -1.61286 9.73388 -3418 4 30.5344 20.24 26.1037 18.6204 0.149313 -5.83605 -3419 4 30.8734 20.4846 24.6365 -0.167457 4.09649 -2.99843 -3420 6 54.9487 26.0868 7.35258 -28.6285 -0.216784 1.76255 -3421 4 54.2955 26.5615 6.794 6.74078 -5.97369 7.99882 -3422 4 54.4034 25.6757 8.0611 9.89476 6.61779 -10.5703 -3423 6 17.8651 35.1614 24.3791 -20.7499 -4.98646 -29.5673 -3424 4 18.0576 34.6235 25.1649 -8.37985 -1.7243 -11.1178 -3425 4 17.2007 34.681 23.779 26.831 10.1018 28.2803 -3426 6 49.1285 3.31358 19.7417 -8.45795 -3.91869 -17.1851 -3427 4 48.8119 4.11203 20.1653 -3.29153 9.9905 4.05996 -3428 4 49.7807 2.96094 20.3466 4.32541 -4.85853 3.16639 -3429 6 30.2844 35.6035 13.4934 7.2001 -0.317469 -2.452 -3430 4 29.4623 35.659 12.9857 1.71884 -1.71824 2.45729 -3431 4 30.0585 35.4328 14.4204 -4.00669 1.3983 -5.34585 -3432 6 43.3887 25.8808 41.6785 -22.9069 -12.3923 -2.55701 -3433 4 43.9997 25.6768 40.9817 12.0928 0.211006 -14.0269 -3434 4 43.8339 26.4255 0.397834 14.8568 14.8319 19.2759 -3435 6 21.0884 23.1529 6.38678 -1.35916 1.28851 13.8592 -3436 4 21.4 23.8645 6.98768 -5.78702 -12.5756 -9.70729 -3437 4 21.3246 23.4545 5.51028 2.40121 5.3387 -13.5131 -3438 6 54.6143 21.1989 19.0895 1.0726 18.3039 13.0104 -3439 4 0.43531 21.5582 19.5367 -15.0683 -8.68203 -12.1911 -3440 4 53.867 21.7044 19.4937 16.3508 -9.47613 -7.9193 -3441 6 13.877 38.9443 18.7624 -3.57764 -10.5141 -5.7706 -3442 4 13.4493 38.4672 19.4981 1.6116 7.10734 -3.21136 -3443 4 14.0821 39.8514 19.0249 -5.40993 2.00969 6.25434 -3444 6 39.1872 2.73234 39.6824 0.14108 0.727177 -8.14712 -3445 4 38.529 2.27328 40.2354 4.03816 -1.16808 -5.22543 -3446 4 39.0548 2.41866 38.7627 -6.48078 -0.982324 12.2661 -3447 6 43.2185 33.8148 8.84061 -19.4182 46.8926 -2.36482 -3448 4 43.1772 32.9719 9.24022 -1.50187 -35.3898 17.2737 -3449 4 42.5163 34.3616 9.29053 19.0727 -15.0644 -10.6104 -3450 6 23.089 16.6827 12.1027 15.7208 -3.2574 -7.89972 -3451 4 23.4385 16.1911 11.3228 -11.6069 8.24456 13.4993 -3452 4 22.136 16.8018 11.9813 0.424679 -1.38664 -3.29845 -3453 6 40.7855 26.1389 36.3196 -19.9126 19.309 9.87347 -3454 4 40.0986 26.8534 36.2514 19.4153 -21.5003 1.38126 -3455 4 41.1517 26.0031 35.4437 4.25962 0.995192 -8.54639 -3456 6 15.1503 11.6717 19.2973 0.724699 -1.19191 17.6918 -3457 4 15.5299 12.2877 18.6792 5.27756 8.7759 -18.41 -3458 4 15.4868 12.0294 20.1269 -4.65024 -4.08223 3.58338 -3459 6 9.86165 29.8154 31.387 -8.94942 -10.7424 5.06077 -3460 4 10.5846 30.1184 31.9716 0.245343 7.83947 -17.0155 -3461 4 9.856 30.1645 30.4637 12.8302 0.479173 21.4055 -3462 6 2.12473 30.035 25.2763 1.78753 8.3758 2.85176 -3463 4 2.08519 29.2167 25.7943 1.54705 3.16986 -12.4779 -3464 4 2.12365 29.8679 24.3136 0.147535 -6.31004 19.3474 -3465 6 49.0081 10.6471 7.05663 3.22839 15.7191 0.010386 -3466 4 49.8069 10.5015 7.59507 -11.7369 -5.9273 -2.35907 -3467 4 48.4474 9.86293 7.09337 3.15572 -10.0552 5.75386 -3468 6 38.6524 34.4248 32.4903 14.0617 12.8107 -4.97275 -3469 4 38.3124 35.2999 32.7524 2.4491 -7.54743 -1.61947 -3470 4 38.3152 33.7696 33.1015 -5.90625 -1.07654 6.02858 -3471 6 24.2925 24.7077 4.76791 -9.60212 12.423 13.627 -3472 4 24.6592 23.9059 5.14091 6.4374 -12.2494 -4.05598 -3473 4 24.0877 25.2629 5.55261 2.76703 -5.61196 -18.2913 -3474 6 44.0394 23.5955 33.7722 -22.1761 -10.7316 25.8053 -3475 4 43.54 23.0408 33.1405 14.8275 10.6039 0.934173 -3476 4 44.7909 24.0173 33.3845 18.136 8.68259 -21.6513 -3477 6 45.1404 31.9557 26.6336 7.63501 -16.8517 -19.5705 -3478 4 44.7419 32.078 27.4825 -5.98757 6.26965 19.5048 -3479 4 44.9572 31.0195 26.4087 0.928196 13.8489 4.22851 -3480 6 52.067 6.35346 22.8527 -23.4258 -19.9992 -0.226773 -3481 4 51.4359 5.65775 23.1792 22.6487 15.1416 -4.78776 -3482 4 51.473 7.11391 22.7826 5.97124 1.02094 -2.8274 -3483 6 5.11659 17.7141 30.4608 -43.6072 -14.7819 8.36724 -3484 4 5.56343 17.5578 29.6371 20.9412 3.52217 -11.7922 -3485 4 5.63141 18.2128 31.0754 22.7819 13.5036 5.79607 -3486 6 48.537 17.0137 6.52887 28.2349 12.1042 -25.3981 -3487 4 48.2628 16.1023 6.56372 -5.81913 -12.4107 2.5618 -3488 4 49.2494 17.0592 5.82246 -25.6562 2.24824 21.9849 -3489 6 13.808 31.3142 23.4689 -3.64011 -9.68131 26.3432 -3490 4 14.1349 31.2178 24.3617 -12.0329 4.75192 12.2102 -3491 4 14.6149 31.173 23.0226 30.8248 -5.26015 -34.1434 -3492 6 28.4946 33.4369 26.0285 16.4638 25.2333 -6.25798 -3493 4 28.7216 32.7387 25.4298 8.48672 -9.67688 -13.795 -3494 4 27.7897 33.0868 26.5316 -24.4903 -9.494 23.2581 -3495 6 9.0435 22.9594 11.008 21.162 0.605596 1.29652 -3496 4 9.33306 22.7779 10.1087 -4.82127 0.713158 -4.26872 -3497 4 9.8456 22.7632 11.5172 -9.5186 2.48902 2.0044 -3498 6 40.5545 4.06728 26.5809 44.6249 -53.7912 6.90123 -3499 4 40.0988 4.06982 27.4038 -17.0162 4.47424 24.8249 -3500 4 40.1579 4.71783 26.0744 -31.5116 46.4114 -32.7723 -3501 6 17.0554 37.9737 20.9489 23.2001 5.84937 -15.1211 -3502 4 17.8184 37.6206 21.4529 -18.1961 -0.773306 2.14347 -3503 4 16.241 37.9215 21.4323 -8.54619 -6.77157 16.0583 -3504 6 31.9589 6.36634 14.2007 -32.7312 -5.18635 1.31695 -3505 4 31.6173 5.45206 14.3159 2.63352 8.72785 -2.4018 -3506 4 32.9006 6.25378 14.1536 18.2531 -4.45925 -0.605861 -3507 6 29.3682 34.9487 39.6588 1.61784 2.82525 -17.5597 -3508 4 29.3689 34.7576 40.5935 -6.77547 -0.101859 12.4897 -3509 4 28.4273 35.0463 39.4168 8.43037 -3.37269 4.33216 -3510 6 22.5699 2.93494 32.1141 -1.63629 -8.86743 4.25418 -3511 4 23.0898 3.67063 31.7669 1.49018 1.71101 -1.29845 -3512 4 22.818 2.15292 31.5827 -1.92581 11.5593 5.09528 -3513 6 51.7444 19.0899 24.8018 18.5566 14.3159 27.8709 -3514 4 52.1262 19.3991 25.6728 -16.855 -8.06891 -29.5747 -3515 4 52.1578 19.634 24.1129 -3.61196 1.33098 2.20453 -3516 6 32.1137 13.664 24.2226 6.2567 1.72658 -37.8727 -3517 4 32.2307 13.7857 25.1378 6.97488 6.10606 45.7276 -3518 4 31.1794 13.5551 24.0935 -22.8325 -3.39176 -1.92521 -3519 6 9.48788 30.1788 28.8037 -7.90151 -0.480281 -10.0021 -3520 4 9.04214 29.3907 28.4657 0.296662 -4.58444 4.12418 -3521 4 9.71381 30.648 27.9899 1.85323 2.91474 4.33114 -3522 6 31.3027 3.12343 24.087 3.70677 4.08208 -3.18372 -3523 4 30.8363 3.94541 23.9161 -7.21645 -1.79011 2.75115 -3524 4 32.1629 3.26377 23.6687 3.35255 -5.74571 3.4439 -3525 6 2.14326 19.8385 36.4613 43.5578 -10.0216 -16.9659 -3526 4 3.05142 19.7594 36.0352 -31.8637 8.98539 19.2185 -3527 4 1.69253 19.0555 36.1346 -14.6763 0.545221 1.96285 -3528 6 36.957 16.7591 14.0918 2.96563 -13.2358 -6.51153 -3529 4 37.0513 17.1687 14.9682 1.23982 -3.45998 -2.6752 -3530 4 37.3406 15.8552 14.1067 -4.20166 12.9403 2.86695 -3531 6 1.82327 11.1921 6.0808 -0.275886 9.47834 -4.04825 -3532 4 1.66503 10.3513 6.51275 0.636708 -7.94921 -0.277572 -3533 4 1.41092 11.8149 6.68093 -3.53423 6.76721 2.7814 -3534 6 43.1526 36.8455 25.2619 -8.14588 -11.3328 3.19442 -3535 4 42.3648 36.774 24.6888 4.17675 -0.750929 11.0286 -3536 4 43.0263 36.2034 25.9927 3.18182 11.8936 -13.2388 -3537 6 32.1279 5.54767 7.01242 2.49094 2.37791 -5.83138 -3538 4 31.9279 4.68363 7.38152 0.218816 -4.41428 4.71371 -3539 4 31.563 6.18782 7.45455 -6.02642 2.24751 5.27561 -3540 6 15.066 21.4965 41.5173 26.6113 -14.2353 0.879596 -3541 4 14.4098 21.4318 0.299313 -13.8163 5.2854 1.00244 -3542 4 14.7314 21.9782 40.7628 -14.3918 6.6959 -6.38566 -3543 6 37.0263 36.0654 5.67599 -8.66989 11.0394 5.08886 -3544 4 36.7926 36.9074 5.26668 1.42879 3.21556 -9.50708 -3545 4 36.6993 36.1724 6.58455 6.67811 -8.44617 -2.15326 -3546 6 39.6264 22.8802 0.345968 -6.61229 0.0560669 1.87747 -3547 4 39.9979 23.7083 41.9266 1.97423 1.58642 1.0556 -3548 4 39.8106 22.8717 1.30105 -0.716498 -2.72173 1.5866 -3549 6 18.4762 23.1875 5.24196 -3.43754 -16.0644 -0.1002 -3550 4 18.2109 24.0785 4.97873 9.26343 12.8459 2.1419 -3551 4 19.3202 23.1705 5.73113 -5.23082 11.7415 -3.58503 -3552 6 34.4866 26.3931 0.410981 -26.1443 -19.9516 50.1306 -3553 4 33.9706 27.0567 0.94736 13.8106 -10.3269 -20.7381 -3554 4 34.4077 25.5868 1.01915 10.7474 25.1704 -28.4611 -3555 6 28.1474 26.0925 40.6196 -28.5345 -18.6936 36.4955 -3556 4 29.0529 26.0026 40.9247 9.18224 2.32741 -2.79367 -3557 4 27.6107 25.644 41.3519 15.6172 17.8969 -31.6189 -3558 6 41.7482 4.39863 30.2421 -5.41295 4.8086 27.4354 -3559 4 42.5847 3.93131 30.2216 8.80522 -6.59194 -7.61494 -3560 4 41.6924 4.68152 31.1831 -5.94926 -0.146025 -12.4776 -3561 6 4.45598 8.30655 29.1222 20.5127 -16.5965 8.52389 -3562 4 3.66946 8.7156 28.7677 -9.60933 13.4518 -0.978151 -3563 4 4.96147 8.97819 29.6123 -10.8114 0.933443 -7.64816 -3564 6 12.9096 9.61234 32.1411 7.95239 -11.3181 7.67023 -3565 4 12.5174 8.82681 31.7782 -9.40951 -4.97415 -8.25208 -3566 4 13.381 9.26623 32.9076 3.83436 11.6436 3.42456 -3567 6 48.6608 16.2478 1.44826 -41.5847 5.12436 -2.24268 -3568 4 49.5977 16.2655 1.51923 27.6715 2.95254 13.2549 -3569 4 48.2356 16.5221 2.2956 18.9339 -8.30142 -14.6437 -3570 6 26.4307 40.0076 21.1903 -9.81311 41.2665 6.04236 -3571 4 27.1749 40.6498 21.1967 -8.04845 -12.0635 0.822588 -3572 4 26.7755 39.1508 21.0026 13.0624 -20.4442 -2.17563 -3573 6 35.79 4.08177 9.00682 -31.6066 0.334495 -4.41207 -3574 4 35.483 4.74976 8.36033 1.0784 -4.66377 5.72074 -3575 4 35.0087 3.86601 9.59196 22.2264 5.21899 -16.6494 -3576 6 52.6895 3.55332 27.8634 16.2443 -8.90238 -17.7273 -3577 4 53.4861 3.5089 28.4695 -19.2533 -5.0216 -23.8454 -3578 4 52.9436 3.34738 26.8904 -3.28408 11.0051 45.9059 -3579 6 48.3169 26.6974 27.3926 25.9077 -23.6746 5.28014 -3580 4 49.0048 25.9927 27.5456 -25.7263 19.495 -6.18754 -3581 4 48.6886 27.4598 27.8411 -2.12981 11.4596 4.51315 -3582 6 24.5097 4.95686 18.7286 -11.1396 -9.34012 13.2359 -3583 4 24.0942 4.18073 19.1756 8.31772 16.1923 -9.35863 -3584 4 23.9484 5.73893 18.8892 6.66511 -10.1227 -0.689949 -3585 6 24.0567 12.4804 28.7686 -1.83015 0.889486 -1.95598 -3586 4 23.1997 12.8888 28.9043 -2.54864 9.49841 4.61676 -3587 4 23.8244 11.6446 28.3683 7.90245 -6.62953 -5.67748 -3588 6 40.1561 27.7426 40.8073 -21.5317 7.14576 -7.35733 -3589 4 40.4932 26.962 41.2601 -12.917 0.0491148 -0.726507 -3590 4 39.1936 27.5721 40.6401 25.9681 1.33069 1.19471 -3591 6 11.9274 13.5458 26.9496 -4.40765 -1.96337 -6.60028 -3592 4 10.9986 13.6678 27.167 -4.51497 -1.32563 0.190923 -3593 4 12.2404 12.8654 27.5442 6.31176 -11.0874 3.59056 -3594 6 52.1902 29.5387 41.394 18.594 -11.3781 3.59259 -3595 4 51.989 30.3087 0.0068425 -9.85392 15.5397 4.91192 -3596 4 53.1003 29.3208 41.6912 -5.64389 -6.04423 -8.59676 -3597 6 17.4867 19.0227 39.1838 -6.27455 21.666 2.75279 -3598 4 17.488 19.586 40.0024 0.860103 -14.9947 -21.9977 -3599 4 17.2876 19.5951 38.4014 5.36511 -12.0476 21.2649 -3600 6 46.2283 27.6807 33.7144 -6.74129 13.676 11.5468 -3601 4 46.0876 28.3582 33.0447 4.86435 -1.49715 -10.0026 -3602 4 45.6533 27.9743 34.4365 0.457797 -3.70748 6.99028 -3603 6 35.8353 29.5439 5.61992 2.49906 -1.59566 -19.7219 -3604 4 35.6527 29.5233 4.66367 4.90114 -0.621078 3.19465 -3605 4 35.4473 30.3766 5.88547 -3.82587 11.7884 10.6864 -3606 6 47.2822 25.7798 30.1513 -10.5766 8.53329 -17.9568 -3607 4 48.1664 25.813 29.7363 -13.2628 3.84456 1.19765 -3608 4 46.6616 26.387 29.6551 21.0058 -12.1546 6.47151 -3609 6 51.3953 12.3638 20.0228 -1.62023 8.46277 -4.73872 -3610 4 50.7529 12.7462 19.4094 4.65296 3.97806 -1.37635 -3611 4 50.8736 11.6867 20.4477 2.10356 -10.8225 11.04 -3612 6 41.9857 18.3757 28.9464 12.9674 -8.39178 -20.9845 -3613 4 42.6678 18.0249 28.3214 -8.5661 8.58724 12.8041 -3614 4 42.4509 18.9846 29.5329 1.95722 -2.13958 -2.01301 -3615 6 53.5955 6.47736 7.49747 -17.4879 -34.0434 -11.6994 -3616 4 53.215 5.56736 7.34717 12.2612 27.0176 1.32153 -3617 4 53.8473 6.47025 8.42428 8.27981 0.813073 3.28926 -3618 6 9.90701 10.6092 26.7593 2.25524 -7.80823 -0.160956 -3619 4 10.2937 10.2906 27.6083 -8.74192 13.2514 -11.8083 -3620 4 9.6719 11.5504 26.8324 5.3909 -8.28719 7.73453 -3621 6 9.32838 39.4044 29.7661 28.1478 19.087 17.9947 -3622 4 10.1636 39.3682 30.3277 -29.6144 2.71186 -18.0569 -3623 4 8.79772 40.1574 30.1092 9.7156 -13.1012 -9.05156 -3624 6 33.3969 4.77935 0.0338577 7.04977 -8.48101 -1.75146 -3625 4 33.7652 5.5373 41.4968 -3.54645 16.0087 -2.35532 -3626 4 34.1271 4.15493 41.8774 -6.76144 -3.49152 6.70786 -3627 6 35.7118 10.6691 34.2465 30.5451 -20.2214 -10.6481 -3628 4 35.199 10.7815 35.0349 -14.696 6.44481 20.012 -3629 4 36.4515 10.0721 34.5187 -16.7263 14.6249 -6.06398 -3630 6 15.1941 17.3851 19.1797 2.70911 -28.1342 -44 -3631 4 15.4897 16.9339 18.3047 -12.3876 19.7973 41.7399 -3632 4 14.2542 17.5546 19.0074 0.407714 2.19657 2.29796 -3633 6 17.478 37.6645 15.4329 -18.9254 1.45878 17.8737 -3634 4 16.9549 37.8023 16.2867 26.4617 -7.60783 -22.0624 -3635 4 18.4074 37.4659 15.6333 -6.79317 3.25497 7.31584 -3636 6 26.2497 8.20945 21.7084 13.406 8.66037 11.1677 -3637 4 26.4123 8.51714 22.643 -13.4745 -7.28424 -22.9055 -3638 4 25.3027 8.1176 21.5293 -5.49097 3.27453 10.4234 -3639 6 0.34 9.90937 15.4047 -28.932 15.8312 -5.67551 -3640 4 1.21626 9.57115 15.2747 8.47529 -16.8828 -5.88536 -3641 4 54.6903 9.41637 14.8207 22.8064 6.49071 10.4803 -3642 6 13.4564 40.6532 9.29599 -22.1307 -5.15585 -0.326819 -3643 4 12.4714 40.4452 9.30279 34.033 7.20134 3.90171 -3644 4 13.9359 39.9749 9.79874 -9.44555 -0.536228 -2.64909 -3645 6 49.5525 25.9167 33.0087 8.30289 -20.978 36.7812 -3646 4 50.1102 25.581 33.7998 -31.2394 16.5759 -41.6702 -3647 4 48.6381 25.5592 33.0807 18.1841 3.33668 -0.378289 -3648 6 37.0921 40.0433 26.4323 -69.9693 32.9093 31.9949 -3649 4 36.1848 39.6472 26.7001 50.2617 0.87061 -16.3943 -3650 4 36.887 40.9984 26.66 23.4133 -30.5831 -16.8038 -3651 6 47.9876 17.8592 12.1588 -8.21233 14.3088 -32.1086 -3652 4 47.5845 18.6288 11.6747 8.44083 -19.6159 16.8154 -3653 4 47.7143 17.8826 13.0665 -7.39134 3.08395 19.3289 -3654 6 27.9663 29.0642 34.1603 1.53587 -18.0299 -1.74725 -3655 4 28.882 28.804 34.3498 -7.37789 1.41773 -2.30399 -3656 4 27.9529 30.0159 34.1809 1.22694 21.8088 1.61581 -3657 6 34.0029 2.78452 13.2168 -24.1529 16.185 8.10865 -3658 4 33.6393 2.32953 13.9926 -4.91269 2.52718 -2.68734 -3659 4 34.7844 2.29731 13.0428 30.2788 -14.7346 -8.06408 -3660 6 28.44 36.053 11.4482 -19.9886 -0.916941 20.5685 -3661 4 28.0041 35.3416 10.9605 0.296796 1.69001 -2.92558 -3662 4 29.0597 36.4216 10.8465 18.9417 8.99323 -20.1084 -3663 6 36.1834 11.364 28.8528 2.80179 -1.8504 -16.6465 -3664 4 35.2026 11.3648 28.9433 17.0081 -1.44193 -10.527 -3665 4 36.4266 11.2403 27.8881 -16.5332 2.0664 24.3605 -3666 6 24.8155 39.488 16.899 1.95651 8.69094 -17.2938 -3667 4 24.2729 40.277 17.0547 2.68209 -2.76325 7.28198 -3668 4 24.7648 39.3887 15.9322 -0.898649 -0.731043 6.96785 -3669 6 49.9432 8.0514 22.8505 -60.8038 -24.1516 -13.0827 -3670 4 49.7668 7.94962 23.7845 10.2147 3.57848 16.1239 -3671 4 49.0378 7.75433 22.5026 41.2245 11.1916 1.13457 -3672 6 52.0935 19.338 10.2277 12.6357 -4.19253 18.0692 -3673 4 51.6063 19.2592 9.39778 1.74616 10.4418 -3.52762 -3674 4 52.4735 20.2434 10.294 -12.5007 -15.5081 -12.5544 -3675 6 24.8386 15.8838 6.12895 -18.3448 14.0073 -0.236232 -3676 4 24.2024 16.3229 6.74681 14.2411 -11.6767 -8.77744 -3677 4 24.4989 16.1625 5.25788 7.11766 -3.93298 6.13727 -3678 6 49.3148 23.6851 8.6303 24.9689 -39.379 16.691 -3679 4 49.2746 22.9584 9.31909 -7.63259 29.9964 -23.4819 -3680 4 48.4638 24.0489 8.3953 -15.5352 0.433996 3.53825 -3681 6 0.208059 10.6481 32.1797 22.1875 -2.28391 4.69689 -3682 4 1.08388 10.2912 32.3483 11.827 -2.86298 -20.6213 -3683 4 54.878 10.581 33.0649 -30.4469 3.74284 18.7822 -3684 6 12.5874 32.9143 13.2407 -35.4131 4.94433 4.95913 -3685 4 11.7345 33.4182 13.1185 22.1299 -14.9844 2.19911 -3686 4 13.2795 33.4792 12.9271 13.1216 10.0242 -5.44208 -3687 6 21.734 32.5657 14.1089 -30.2641 -10.609 17.8788 -3688 4 21.1735 33.3586 14.1938 13.4775 0.171544 -7.80997 -3689 4 21.2373 31.9121 14.6504 18.4585 12.3126 -12.4653 -3690 6 48.1656 34.8484 27.3207 -34.4178 -12.3509 -32.6658 -3691 4 47.5287 35.1179 27.9926 9.598 2.53078 9.45385 -3692 4 47.5616 34.4813 26.6056 29.2581 12.2879 19.461 -3693 6 45.6153 31.2627 36.0943 -37.261 16.4569 21.0579 -3694 4 45.7916 31.8927 35.3904 -0.807743 4.61331 -8.81752 -3695 4 44.8366 31.6277 36.6156 19.759 -7.25665 -17.1647 -3696 6 46.2873 0.296503 14.3622 0.346279 -8.22198 0.0964187 -3697 4 46.2502 1.23933 14.2464 -13.6881 13.1616 4.37405 -3698 4 47.2018 42.0236 14.1712 14.709 -12.2876 -2.23521 -3699 6 14.3299 18.994 40.2006 -30.7379 -32.6603 -9.06287 -3700 4 14.4791 19.2338 39.2972 7.93482 8.11578 -14.4624 -3701 4 14.6855 19.6458 40.7662 17.9566 28.0241 18.1173 -3702 6 14.5596 1.14026 10.2341 26.3279 -2.23148 -9.5451 -3703 4 15.4055 1.22344 9.73443 -17.3894 7.51472 10.761 -3704 4 14.1379 0.381418 9.8097 -7.55267 -3.97863 3.86231 -3705 6 34.4334 40.9199 12.9894 -0.940803 4.29697 -17.7271 -3706 4 34.039 40.5607 12.1545 5.82782 2.6847 22.9711 -3707 4 34.273 40.3011 13.7266 -2.01031 0.481385 -16.696 -3708 6 42.1477 25.6267 33.9881 24.0417 -24.4569 -2.75436 -3709 4 41.6299 25.3559 33.2134 -0.0206438 0.202706 6.41118 -3710 4 42.855 24.9213 34.0976 -22.0628 21.5276 -5.85955 -3711 6 29.1852 22.5895 40.0737 -4.6165 -6.65381 -10.571 -3712 4 28.5947 23.1672 39.581 -0.582997 4.41945 3.85107 -3713 4 29.0675 22.7332 41.0074 -2.93269 3.94269 10.2267 -3714 6 44.8062 18.6252 1.49818 5.72139 3.58279 15.6322 -3715 4 44.9314 18.8801 2.44529 -3.9019 -2.65234 -18.9387 -3716 4 44.0985 19.1782 1.14518 3.29812 2.13948 3.69359 -3717 6 4.47265 10.8135 23.9407 -24.2902 -18.4562 11.3409 -3718 4 5.11906 11.4142 23.6391 22.3407 21.5355 -19.7447 -3719 4 4.51291 10.8829 24.8932 -6.80118 0.381125 6.4492 -3720 6 6.46087 23.0097 28.9948 -0.180046 29.3158 3.74757 -3721 4 7.16357 23.1777 29.6697 -12.977 -15.1924 -17.9731 -3722 4 6.42476 22.0762 28.8013 7.623 -17.0728 6.50296 -3723 6 39.796 25.1427 32.5747 9.70804 -1.04373 -32.2987 -3724 4 39.5377 25.4516 33.4106 -12.9416 11.3784 38.6909 -3725 4 39.6539 25.9218 32.0211 1.09764 -5.16827 -8.54386 -3726 6 40.8629 21.4836 8.86543 0.741147 13.6451 -7.24725 -3727 4 40.6441 21.3431 7.92826 2.29745 -6.5969 8.98303 -3728 4 41.3236 20.7041 9.20266 3.81714 -8.25026 -3.81722 -3729 6 0.635293 1.4289 12.9408 -11.8573 10.3167 -17.0811 -3730 4 54.7874 1.76314 12.6159 9.08744 8.74788 -10.2417 -3731 4 0.270536 0.805051 13.547 10.8795 -21.9384 23.5147 -3732 6 32.6734 29.7199 23.4842 -6.31159 -22.9731 3.95312 -3733 4 32.3164 28.805 23.472 7.37478 14.3791 4.20759 -3734 4 32.5291 29.9779 22.5736 0.738758 10.2783 -10.1223 -3735 6 12.5322 37.1564 20.4866 30.6876 51.3804 29.6269 -3736 4 13.0449 37.1468 21.3313 -10.4644 -1.04639 -16.0138 -3737 4 12.1935 36.3015 20.3752 -17.5174 -49.5479 -6.43685 -3738 6 13.879 14.5208 24.6979 -2.0089 -0.488943 14.0828 -3739 4 13.5126 15.2415 24.1863 -2.86121 7.01781 -5.24136 -3740 4 14.0435 14.8889 25.5812 -0.885703 0.504049 -6.33424 -3741 6 17.5084 27.0547 26.4789 25.7109 3.2743 -38.4356 -3742 4 17.3703 27.9297 26.0618 -4.07905 -12.769 13.7294 -3743 4 18.1097 26.6273 25.8042 -17.4354 5.34049 24.3014 -3744 6 54.4807 9.52867 26.3526 -8.08409 11.5192 21.059 -3745 4 54.0543 10.3952 26.5681 7.59002 -15.9534 -5.94965 -3746 4 54.8701 9.18952 27.1901 -5.85154 7.09102 -14.0848 -3747 6 33.6811 21.5047 24.9231 9.13792 -2.03882 -43.3211 -3748 4 33.6373 21.3676 23.9235 3.71376 4.25849 32.7793 -3749 4 32.846 21.1613 25.2346 -13.4677 -6.75943 10.2286 -3750 6 22.147 35.267 2.89295 -1.50127 3.24452 17.3348 -3751 4 22.2381 34.4 2.47628 0.948748 -2.82555 0.0189077 -3752 4 22.0999 35.1233 3.8735 0.523717 -2.91888 -18.7193 -3753 6 45.3111 5.3951 15.6139 -0.0233827 -18.9082 29.3701 -3754 4 45.1442 5.22798 16.5663 9.63366 2.6406 -14.7931 -3755 4 44.5125 5.84005 15.3428 -8.81534 4.22624 -14.6387 -3756 6 5.67663 7.59044 16.9735 -0.040306 4.08799 -12.5895 -3757 4 5.28026 7.88599 16.128 7.47401 -1.2917 10.5251 -3758 4 6.58383 7.937 17.01 -0.793937 -3.87211 -2.68331 -3759 6 34.58 39.0977 27.2045 1.42769 14.436 -3.31523 -3760 4 34.2907 38.4975 27.863 -0.77861 -26.0942 16.6839 -3761 4 34.0642 39.8725 27.4397 -1.42861 13.6713 -5.6929 -3762 6 32.7657 33.6085 34.293 -22.4583 20.5671 -18.6673 -3763 4 32.1806 34.0441 33.6111 23.9751 -17.2665 15.818 -3764 4 32.4638 34.0082 35.1245 2.30326 -6.42306 -1.86009 -3765 6 30.988 41.2133 32.384 -4.02481 -7.82035 -3.95856 -3766 4 30.2267 41.2202 32.9774 -4.32902 6.50081 -0.328838 -3767 4 31.0509 0.17511 32 -1.2051 10.1503 -2.92525 -3768 6 7.6493 1.59177 27.1464 22.3535 -22.6118 -16.4669 -3769 4 8.41104 1.29664 26.5499 -29.8997 15.2665 16.3611 -3770 4 7.54328 2.53873 27.061 4.65755 9.49162 -4.22239 -3771 6 0.888965 22.101 37.8501 15.4112 -23.8094 -16.9331 -3772 4 1.26739 21.3109 37.3638 -11.0686 24.0488 15.8162 -3773 4 1.18 22.8712 37.3372 -1.61814 -2.27923 2.93708 -3774 6 7.39632 11.121 19.2332 -2.86932 4.41375 3.62624 -3775 4 7.58751 12.0436 19.3904 -7.23274 18.3647 6.41875 -3776 4 8.29083 10.7877 19.1848 5.97481 -12.1861 -3.76707 -3777 6 43.7816 12.5054 37.3126 2.86093 2.78929 -1.28281 -3778 4 43.9727 12.4749 36.3586 -3.06612 0.785718 5.83621 -3779 4 44.6572 12.6706 37.7021 -4.14278 -2.20963 -1.61523 -3780 6 29.0947 33.5132 36.1777 7.61955 17.1376 -26.1106 -3781 4 29.8261 34.0815 35.8667 -13.5031 -6.20718 4.51186 -3782 4 29.4784 33.1216 36.9462 10.9925 -12.9866 20.6523 -3783 6 14.807 4.60084 3.93512 20.0881 9.19657 -13.3363 -3784 4 14.316 4.04064 3.33426 -13.0632 -7.60853 1.79497 -3785 4 15.6236 4.79338 3.42413 -10.111 -0.253003 10.8348 -3786 6 39.0437 6.41097 6.40143 -11.952 4.4329 11.9095 -3787 4 39.4604 7.16771 6.02322 8.12547 27.0605 -0.357881 -3788 4 39.3566 5.75952 5.7919 -0.567413 -21.3616 -5.48613 -3789 6 22.2146 37.9992 40.767 -9.02066 -17.4896 -19.1754 -3790 4 22.494 38.8839 40.5618 6.85259 22.4587 -5.93601 -3791 4 22.4583 37.8811 41.6743 4.99519 -4.33654 23.0463 -3792 6 4.4524 23.286 6.15211 29.8095 -7.21279 -13.1375 -3793 4 3.81791 23.938 6.45512 -14.4589 -6.71938 9.72163 -3794 4 4.31449 22.3781 6.49744 -8.68344 13.1635 4.00749 -3795 6 12.4271 23.7748 9.24631 -1.26755 4.43152 21.3749 -3796 4 11.5607 23.6235 8.88266 -11.7175 -2.77193 -9.11925 -3797 4 12.2509 24.3149 10.0432 11.3809 -1.60307 -13.9136 -3798 6 46.4989 15.2625 16.9679 -12.8481 -2.49131 10.8408 -3799 4 47.085 14.9252 16.2779 8.49272 6.07271 -3.86524 -3800 4 46.8927 16.0486 17.3753 9.61298 -1.72862 -3.23202 -3801 6 34.1182 27.164 19.7815 17.9289 -11.392 6.58771 -3802 4 34.8637 26.5005 19.7508 -17.7467 14.3364 5.12367 -3803 4 34.0077 27.4664 20.702 3.31322 -6.80894 -12.4792 -3804 6 46.9518 13.2225 35.1059 11.5726 -0.299351 34.0182 -3805 4 47.3951 14.0533 34.9197 -1.30218 2.22738 -12.772 -3806 4 46.5273 12.8898 34.3328 -6.46075 0.0352155 -21.0879 -3807 6 50.5846 18.7905 12.5321 0.161349 -2.47544 -10.5355 -3808 4 49.7474 18.3698 12.2516 10.3296 3.30344 0.704295 -3809 4 51.1853 18.7954 11.7538 -11.6392 0.795373 7.80699 -3810 6 32.4849 12.6316 31.9547 13.623 -32.1984 -17.1952 -3811 4 32.7548 11.6805 31.9646 -3.77817 17.5545 -6.43374 -3812 4 32.3724 12.7906 32.8759 -7.39939 11.2146 27.5789 -3813 6 6.21204 19.6856 10.0139 6.84548 18.8235 13.1049 -3814 4 6.54027 20.2383 9.28123 0.761161 -1.37122 2.72757 -3815 4 6.08461 20.3138 10.7689 1.69871 -13.3343 -16.4193 -3816 6 21.5267 21.5372 2.4283 -5.72751 11.2346 -5.82425 -3817 4 21.7624 21.5115 1.48057 4.80944 -6.6677 9.03128 -3818 4 21.9699 20.8013 2.88237 1.68469 2.19074 -10.3234 -3819 6 38.389 23.0803 17.19 -15.8009 11.2489 14.8144 -3820 4 38.843 23.3405 16.3672 7.30113 -17.2523 7.40945 -3821 4 38.5581 22.1678 17.4979 8.57434 6.38113 -15.3203 -3822 6 29.7009 24.9705 22.2505 40.9979 -45.9373 -29.6811 -3823 4 30.2007 24.9541 23.0531 3.51493 7.58579 28.6285 -3824 4 28.9709 25.5198 22.3387 -45.941 40.092 17.1582 -3825 6 30.3026 21.4444 37.7784 -57.0222 17.1687 -23.3742 -3826 4 30.3615 21.3347 36.805 9.38026 -2.23221 21.4717 -3827 4 29.3011 21.6413 37.9016 49.3444 -12.8915 1.59191 -3828 6 11.8723 11.7062 16.3108 -33.4349 -15.0686 -41.1118 -3829 4 11.3207 12.2631 16.8681 -3.98396 2.02201 -1.40695 -3830 4 11.3108 11.5232 15.4705 24.8968 9.48818 41.0096 -3831 6 5.70652 16.9717 10.4705 4.17204 -12.2255 5.26049 -3832 4 4.89872 17.0293 11.0039 1.44556 1.21447 -8.81597 -3833 4 5.85075 17.8293 10.0626 -3.65007 4.58518 2.58079 -3834 6 41.6977 34.1692 35.8837 -2.16171 7.35997 35.3278 -3835 4 41.9434 35.0359 36.2767 -7.39108 -12.3774 -11.2945 -3836 4 41.6554 34.2509 34.9408 0.248654 6.88642 -24.6778 -3837 6 33.755 1.15956 30.1148 26.9661 -5.30311 0.785489 -3838 4 32.8327 1.41064 30.2749 5.35845 -2.81639 19.5818 -3839 4 34.3082 0.981132 30.9387 -30.8845 7.54253 -18.2089 -3840 6 50.3537 18.6141 36.9811 22.0078 18.2711 -1.17075 -3841 4 50.0553 18.9081 37.8421 -3.0234 4.11827 7.26126 -3842 4 49.7241 17.9789 36.6994 -26.7065 -28.1871 -12.5747 -3843 6 24.6713 24.2747 40.2422 -22.5478 13.5437 8.83718 -3844 4 23.7682 24.4281 40.6159 16.469 -5.34198 -8.29501 -3845 4 24.8078 23.3187 40.2616 -1.76472 2.5507 -0.358513 -3846 6 37.3089 22.0315 23.2412 -5.67505 16.6134 8.34505 -3847 4 36.9227 21.8066 24.1113 8.4343 -8.15598 -10.5545 -3848 4 37.8295 21.3076 22.8826 1.63944 -5.88141 4.04288 -3849 6 48.4175 40.505 28.9613 -8.44239 17.3351 -31.8351 -3850 4 48.9168 41.2502 28.5701 -3.67522 -6.90368 3.5913 -3851 4 47.6498 40.4225 28.3398 9.75729 -4.39015 14.633 -3852 6 24.8456 8.73476 16.5822 -4.20971 0.107082 12.7896 -3853 4 25.4166 9.33437 17.0882 0.801486 -3.84637 -6.6671 -3854 4 25.3552 7.93888 16.3774 1.47583 -1.66023 -1.71228 -3855 6 19.2415 22.9983 32.4591 18.0731 -7.21062 -7.32059 -3856 4 18.4972 23.4837 32.0941 -3.55414 -1.2008 3.19393 -3857 4 18.9283 22.447 33.1757 -6.31405 0.951806 3.86493 -3858 6 3.33315 21.6719 22.4471 -31.3651 -15.1442 10.7623 -3859 4 2.72119 22.0562 23.134 20.4737 -7.45649 -18.1084 -3860 4 4.09369 22.238 22.38 14.9219 12.7334 2.89238 -3861 6 10.2287 20.327 12.827 -13.2346 -13.5387 -5.73443 -3862 4 9.59835 20.9044 13.2794 3.30523 -1.6991 -3.3419 -3863 4 9.66163 19.6709 12.3619 8.96671 11.3846 7.22783 -3864 6 9.52445 0.665703 25.3447 51.6699 36.9138 -22.1471 -3865 4 10.407 0.70007 25.8038 -28.3091 -11.588 2.11711 -3866 4 9.73816 1.30323 24.5834 -23.5062 -26.9191 23.3279 -3867 6 10.6629 40.7098 9.64162 -13.7092 -10.0604 -17.7529 -3868 4 10.6663 41.3337 10.3633 -2.25222 9.44489 9.13119 -3869 4 9.9177 40.9644 9.04966 14.1089 -1.91013 12.7496 -3870 6 46.3583 25.2138 32.6818 -7.00173 28.401 24.5039 -3871 4 46.1658 26.0815 33.1748 9.63216 -40.3762 -24.4036 -3872 4 46.6683 25.4845 31.8081 -0.340565 -0.626762 -0.366217 -3873 6 38.9398 3.19835 23.1062 35.7507 -3.98021 4.80576 -3874 4 38.0789 3.42388 22.7807 -21.691 0.0477325 0.592254 -3875 4 38.9606 2.6551 23.9199 -14.9585 3.95725 -7.0779 -3876 6 33.3518 23.6324 36.8776 -10.909 11.1506 22.2396 -3877 4 32.7475 23.7189 37.6717 16.9933 -10.7727 -23.1962 -3878 4 33.5054 24.5617 36.6454 5.48307 -3.56245 -8.14833 -3879 6 51.9403 33.327 25.4307 18.0164 46.0043 -41.5452 -3880 4 51.481 33.1217 26.2288 -14.6019 -1.8433 25.1586 -3881 4 51.8744 34.3335 25.2555 2.07578 -44.1738 12.4077 -3882 6 32.1773 25.016 33.1611 -3.65323 12.5958 -4.40686 -3883 4 32.7417 25.8243 33.1248 -13.2213 -13.5953 2.20315 -3884 4 31.2567 25.3353 32.9959 15.6883 -4.24783 1.324 -3885 6 51.2804 27.7082 39.5058 -12.4055 -13.8576 13.4454 -3886 4 51.6333 27.8214 38.6405 7.56348 -1.28822 -27.9214 -3887 4 51.668 28.4332 39.9759 4.38661 13.1583 16.7532 -3888 6 34.2776 28.325 17.2612 18.5433 -9.6807 0.726105 -3889 4 33.4618 28.7621 17.0499 -21.6526 10.7978 2.5619 -3890 4 34.2928 28.1986 18.2187 -4.64072 -2.98555 4.57564 -3891 6 36.914 8.0422 37.8636 -11.4128 -16.3489 28.1347 -3892 4 37.1972 8.46051 37.0352 12.2245 9.0272 12.2411 -3893 4 37.2151 8.41454 38.7513 -7.64029 -1.69915 -40.4466 -3894 6 34.8876 19.4054 6.12727 15.6033 7.52257 2.15709 -3895 4 34.0531 18.9355 6.15655 -6.74313 -1.04378 -1.75599 -3896 4 34.6977 20.3552 6.00766 0.606543 -4.24654 -1.2187 -3897 6 52.9513 9.46866 7.83406 2.51792 52.5995 -46.1577 -3898 4 52.8182 10.1965 7.1313 21.8169 -33.4663 26.408 -3899 4 52.1097 9.49548 8.25498 -20.9439 -11.3984 23.93 -3900 6 36.2784 5.48477 38.9735 -18.6298 -4.41122 2.56352 -3901 4 36.9459 5.47799 39.6359 15.3203 -14.8264 18.8091 -3902 4 36.5882 6.23606 38.5023 -2.18903 24.2959 -30.3279 -3903 6 10.0091 14.4595 13.4727 4.14065 20.8003 14.1725 -3904 4 10.1735 15.3719 13.8184 -7.35802 -17.2864 -8.75733 -3905 4 9.20522 14.5177 12.9398 -1.57173 0.82324 -0.279823 -3906 6 17.2166 24.3595 39.7866 10.3316 -24.6644 9.74438 -3907 4 16.8461 25.2181 39.6219 -11.8102 15.8188 2.99696 -3908 4 16.9967 24.0978 40.7081 2.51259 6.67153 -9.86646 -3909 6 49.0842 32.5535 7.76087 3.66191 -12.3496 8.85055 -3910 4 48.2705 33.0417 7.89853 -4.87459 2.09702 3.01394 -3911 4 49.5463 32.9698 7.04629 8.35168 7.01386 -14.6239 -3912 6 44.8849 24.3899 5.46806 25.9844 8.68062 13.8603 -3913 4 44.662 24.5947 6.37974 6.74107 7.22813 10.7323 -3914 4 44.0754 24.0079 5.20592 -32.7636 -20.0017 -25.3594 -3915 6 37.3054 29.188 32.8461 11.1431 -5.59449 16.1726 -3916 4 36.8523 29.4202 33.6742 6.83247 1.44061 -4.51415 -3917 4 36.6742 29.3068 32.1579 -22.7291 3.94299 -14.9304 -3918 6 0.907991 24.8221 21.2346 15.0832 19.7352 -4.57067 -3919 4 1.06453 25.2816 20.3717 -1.39622 -8.03116 21.3543 -3920 4 1.45755 25.2897 21.9154 -11.7661 -11.1398 -13.6241 -3921 6 53.0192 2.206 13.0014 -0.818186 11.5483 2.08343 -3922 4 52.7824 1.81345 13.8314 -6.90556 -15.4066 8.50991 -3923 4 53.4537 3.0128 13.31 2.83183 5.68595 -7.528 -3924 6 24.3052 33.9756 13.9324 20.4312 -11.5489 10.0229 -3925 4 23.7773 33.1726 14.1229 5.8111 10.1191 -2.33499 -3926 4 25.2169 33.8698 14.327 -30.0349 3.28274 -10.0023 -3927 6 40.9302 19.2912 0.318024 -15.3988 27.4065 1.86032 -3928 4 41.1581 18.3902 0.297675 9.36546 -44.4479 -0.119704 -3929 4 41.7646 19.7516 0.396104 7.20249 9.57203 1.55489 -3930 6 38.311 32.026 21.5914 -16.5672 24.1097 -12.7773 -3931 4 37.7777 31.3762 21.1012 4.07846 0.69211 1.97712 -3932 4 37.9765 32.9287 21.3171 8.34414 -28.994 10.9395 -3933 6 42.3062 34.9979 16.9676 -25.16 18.3345 5.87282 -3934 4 41.5364 35.0784 17.5803 19.0968 -0.611651 -8.13832 -3935 4 42.7061 34.1505 17.1117 7.13758 -14.417 1.0169 -3936 6 19.559 24.3289 21.9471 -10.3882 -39.985 28.3228 -3937 4 19.0651 23.5074 22.2416 22.0177 25.9498 -5.97634 -3938 4 18.911 24.732 21.3859 -10.0006 10.9377 -12.5795 -3939 6 21.0734 3.08215 14.9508 5.66735 1.93263 4.27485 -3940 4 21.953 3.50152 15.1067 -15.9394 -6.36392 -7.95302 -3941 4 20.9814 2.87634 14.0019 2.73511 2.88399 3.27523 -3942 6 16.4416 12.1461 28.5328 0.855962 3.79198 1.54672 -3943 4 16.9672 12.6551 29.168 -2.37031 -0.949071 -4.41291 -3944 4 15.802 12.7688 28.1665 0.405815 -3.95107 1.98596 -3945 6 29.5641 4.71626 21.7415 17.492 -20.3905 -14.0863 -3946 4 29.717 3.79719 21.4198 0.937107 17.7735 8.56359 -3947 4 28.6765 4.939 21.4721 -9.06619 5.19467 -0.439365 -3948 6 47.4133 12.088 13.4013 -19.6032 -12.6622 16.1152 -3949 4 46.7677 12.2286 12.6843 7.8139 0.82382 7.69043 -3950 4 46.8958 11.6888 14.1608 19.5987 16.3505 -27.3211 -3951 6 26.4348 0.0314913 5.59163 -38.6673 11.9556 1.59378 -3952 4 25.5144 0.513751 5.59151 44.3701 -31.5426 2.21012 -3953 4 26.2832 40.9933 5.84663 -4.6239 23.4679 -5.56234 -3954 6 20.8211 34.8097 41.3598 6.97593 19.5597 16.9804 -3955 4 20.8796 35.753 41.6458 -3.00787 -20.9192 -8.75426 -3956 4 21.5767 34.358 41.784 -4.89338 4.10004 -2.4608 -3957 6 12.6876 17.479 1.38718 -1.79098 16.5747 12.6529 -3958 4 12.721 17.2085 2.3151 1.79447 -6.15344 -4.56661 -3959 4 12.6249 16.7029 0.834077 -0.882684 -12.7315 -6.97767 -3960 6 30.0809 10.1879 8.41184 2.17826 -2.71045 -21.4672 -3961 4 29.3744 10.7602 8.07412 2.70218 -2.7161 1.39802 -3962 4 29.921 10.0821 9.33998 -2.4398 0.0699553 19.6849 -3963 6 36.338 5.45526 23.9203 5.99313 10.0946 16.1749 -3964 4 36.1182 6.35936 23.6236 3.48165 -5.42435 1.21963 -3965 4 37.0503 5.55216 24.5976 -11.7354 -2.45534 -11.6386 -3966 6 34.0137 39.9398 19.5054 17.9066 -9.75089 21.0607 -3967 4 34.5988 39.5452 20.1731 -15.7075 -1.02338 -1.83906 -3968 4 34.6431 40.5289 19.082 -7.6391 9.5881 -14.1485 -3969 6 25.1112 29.0201 17.0007 35.0878 36.529 -22.1514 -3970 4 24.4917 28.3695 17.2244 -30.3786 -36.8419 16.5077 -3971 4 24.8604 29.2867 16.1023 2.15056 -2.21883 6.37313 -3972 6 28.5036 21.3308 6.52422 21.0338 -5.55128 30.7615 -3973 4 28.0688 21.6386 5.71574 5.06238 16.4658 -0.926129 -3974 4 28.989 22.0506 7.05137 -24.5794 -13.751 -30.0602 -3975 6 18.6637 26.1498 0.432001 -8.53447 25.4727 10.2843 -3976 4 18.1393 25.3713 0.533905 -9.92127 -26.6833 -5.54807 -3977 4 18.1707 26.7698 1.00478 10.6071 3.27379 -7.60185 -3978 6 10.9817 29.7047 15.4617 -41.5317 11.7513 13.4553 -3979 4 11.6879 29.3608 14.9846 35.2501 -21.9962 -32.1318 -3980 4 11.3889 29.9926 16.2601 5.02956 8.45945 23.8164 -3981 6 33.4827 3.76017 10.5773 -2.41261 -0.304069 24.838 -3982 4 33.4731 3.39919 11.5182 2.46452 11.5285 -31.0446 -3983 4 33.5847 4.73535 10.6555 -0.240223 -15.9168 2.16837 -3984 6 12.2973 28.805 23.0387 -1.70787 -5.55619 5.61474 -3985 4 12.73 29.6571 22.9381 2.67417 5.94729 -0.690524 -3986 4 11.5024 28.994 23.5653 2.03311 -0.198261 -3.05575 -3987 6 13.0915 10.291 41.0216 -35.9662 5.53295 8.52282 -3988 4 13.8386 10.0408 41.5246 29.6538 -8.48465 17.7322 -3989 4 13.4107 10.5366 40.1733 8.17866 7.18603 -23.992 -3990 6 45.8162 29.981 22.3537 -23.4909 -34.782 -9.94688 -3991 4 46.3605 30.6906 22.6479 19.8522 18.211 11.3118 -3992 4 46.1638 29.1315 22.7274 -3.04842 19.9099 -5.39144 -3993 6 41.5671 12.1372 14.78 12.0724 6.03101 -10.0784 -3994 4 40.8481 12.1001 15.4119 -11.2612 -2.38036 6.73971 -3995 4 41.9114 13.0311 14.8874 5.93112 4.19505 -0.667369 -3996 6 18.1729 7.20363 24.1739 -28.0382 48.7978 3.52623 -3997 4 17.4064 7.85498 24.128 33.406 -18.9268 -1.93395 -3998 4 17.7199 6.38321 24.1568 -14.2968 -40.16 -0.285645 -3999 6 1.47767 28.308 7.57167 -25.5616 27.2209 -25.1393 -4000 4 0.827452 27.622 7.68711 2.49251 -16.9659 6.86802 -4001 4 0.906232 29.0217 7.18328 24.331 -5.18373 6.93061 -4002 6 11.3359 12.3164 24.0718 -23.8013 37.4997 -14.7667 -4003 4 11.6691 13.0224 24.6595 3.51665 -15.1291 3.43827 -4004 4 11.6925 11.4858 24.3227 20.8697 -21.176 20.4973 -4005 6 17.9852 40.4684 24.4198 -2.05389 -13.7174 33.2687 -4006 4 18.291 40.9889 23.6947 8.79563 24.1615 -11.819 -4007 4 17.8495 41.0209 25.2243 7.13458 -7.65509 -20.9696 -4008 6 25.5964 7.43792 34.0141 13.5012 12.0052 -20.5927 -4009 4 25.8913 7.969 33.2287 -3.90825 -14.1502 17.4414 -4010 4 24.6674 7.63663 34.1466 -9.57807 0.741149 3.27376 -4011 6 16.9692 36.3856 7.79034 -41.9934 -28.8773 9.66508 -4012 4 16.1027 35.9203 7.98218 37.4859 8.56847 -14.648 -4013 4 16.8197 37.2026 8.24874 12.7807 20.325 5.07796 -4014 6 12.4125 39.1679 36.8113 4.83627 -30.6012 -9.1357 -4015 4 13.2866 39.4994 36.9682 3.20673 22.8904 8.84646 -4016 4 12.7018 38.3069 36.4569 -23.4958 5.90479 1.90955 -4017 6 23.4443 1.91649 37.7131 1.30421 0.985484 -2.89526 -4018 4 22.7028 1.66545 37.1374 7.60384 11.2995 4.79583 -4019 4 23.7753 2.79308 37.4363 -6.35903 -5.24233 -3.11404 -4020 6 26.6169 34.8556 39.068 -18.8945 24.0174 -16.1573 -4021 4 25.9011 35.0209 39.7003 9.00825 -5.11239 -0.809586 -4022 4 26.448 35.531 38.356 7.64302 -20.2436 14.8851 -4023 6 44.7566 35.572 23.174 8.53117 -4.94531 -21.3447 -4024 4 44.5551 36.3183 23.7275 -7.66893 11.3086 12.1688 -4025 4 44.9082 35.9286 22.2729 -0.906387 -11.1819 10.3159 -4026 6 34.6091 35.4265 26.6991 -7.96701 8.74937 -1.29134 -4027 4 33.7558 35.2865 27.1578 16.0802 3.93421 -4.37465 -4028 4 35.2785 35.5457 27.4013 -9.86041 -2.80018 -4.60569 -4029 6 12.4308 29.8402 9.37325 4.00701 15.5633 13.1387 -4030 4 12.6298 30.2095 10.2592 0.427445 -8.8693 -11.9579 -4031 4 11.9163 30.5385 8.94302 -0.259504 -4.09781 -0.505047 -4032 6 46.4536 41.3715 16.9585 -0.509472 -10.7221 -3.48983 -4033 4 46.3968 0.20327 17.5639 0.209317 7.43894 6.10767 -4034 4 46.3711 41.769 16.0793 0.075994 -2.20044 0.741492 -4035 6 39.1811 31.047 24.0166 -28.3946 14.7902 -31.7872 -4036 4 39.0009 31.2944 23.0615 15.0891 -8.50563 28.3067 -4037 4 38.282 31.1199 24.3765 13.6746 -2.33731 7.34059 -4038 6 40.5375 9.75603 28.9763 9.47615 -22.8392 -16.3574 -4039 4 40.717 8.78834 28.9749 -4.02124 18.0325 0.597023 -4040 4 40.0442 9.94417 29.7674 -4.45736 4.50836 13.2228 -4041 6 33.5752 11.9033 22.735 -22.7947 23.9621 15.9921 -4042 4 33.2963 12.1808 21.8555 7.18969 -8.33444 -8.87292 -4043 4 33.0376 12.5465 23.2695 22.9257 -24.0379 -3.52442 -4044 6 29.0301 38.739 2.44557 13.7604 -11.9544 -20.6568 -4045 4 29.2066 39.6607 2.23242 1.09325 2.62923 1.14408 -4046 4 28.4566 38.7797 3.20164 -8.68487 1.4276 10.4377 -4047 6 51.2789 6.14828 28.303 0.614736 -0.570337 1.8431 -4048 4 51.6973 5.27456 28.1665 -1.53436 11.093 -0.261734 -4049 4 51.6265 6.73477 27.6091 2.17001 -12.1019 4.10374 -4050 6 34.1129 16.6124 14.0322 -32.0491 -20.8609 -4.49638 -4051 4 33.8537 17.5241 13.9801 -4.99199 17.3104 -1.82528 -4052 4 35.0495 16.5739 14.0336 36.3732 5.94549 -0.19423 -4053 6 34.4398 40.0505 7.51971 -1.5967 1.86622 -34.5907 -4054 4 34.4907 40.736 6.82898 6.47702 11.7366 29.0204 -4055 4 34.1466 39.3906 6.89306 -3.09667 -23.6565 15.965 -4056 6 42.5416 22.9885 4.36731 16.709 1.02816 -9.65968 -4057 4 42.6773 23.0677 3.40021 -12.3994 2.37358 9.8727 -4058 4 41.6332 23.2481 4.59133 5.34809 1.54884 -5.45539 -4059 6 1.43335 11.7249 10.5915 17.9648 34.7983 -1.93775 -4060 4 2.18855 11.6351 9.93392 -25.2532 9.63542 18.7746 -4061 4 1.3761 12.7012 10.8984 13.7257 -41.7135 -20.7702 -4062 6 10.0197 17.1509 40.4023 -3.34945 -21.541 12.0793 -4063 4 9.07741 16.8499 40.449 26.596 5.40866 2.75879 -4064 4 10.6028 16.482 40.874 -24.6204 18.7768 -14.392 -4065 6 26.3793 1.16939 23.7984 9.5834 26.112 -20.0106 -4066 4 26.3482 1.63114 22.915 -1.08564 -15.7005 23.7132 -4067 4 26.8817 1.81632 24.3342 -3.35925 -10.5223 -0.68284 -4068 6 4.47487 16.2271 39.0058 33.4959 -10.553 -10.6989 -4069 4 4.63618 15.8937 38.0801 -2.33968 7.70086 24.4633 -4070 4 5.35244 16.1813 39.5129 -32.5033 1.65679 -19.7071 -4071 6 24.3835 39.8482 14.0852 2.84697 7.18038 -0.286146 -4072 4 24.1877 40.6985 13.6429 5.77715 -11.144 2.19115 -4073 4 25.1234 39.4426 13.6288 0.754333 1.29636 -3.16103 -4074 6 19.9701 19.0136 10.1131 -5.22385 -12.8057 23.8822 -4075 4 19.1001 19.3633 10.3498 -0.643873 5.13605 -7.14836 -4076 4 20.1315 18.3631 10.8504 3.64009 16.176 -24.2707 -4077 6 45.2329 15.0638 25.3099 -19.5547 20.2245 12.2671 -4078 4 44.4482 15.622 25.4263 4.62838 7.04728 2.57625 -4079 4 44.8851 14.3824 24.752 0.155489 -22.5403 -14.0061 -4080 6 47.6439 32.9533 29.9771 4.38746 -1.69347 6.40492 -4081 4 47.8622 32.5347 30.8309 -5.05982 6.77924 -7.14273 -4082 4 46.6855 33.0215 29.8843 -3.06966 -4.44082 4.14054 -4083 6 9.30872 14.1631 35.6268 19.7088 14.7601 29.7215 -4084 4 10.221 13.8687 35.4779 -5.99131 -8.3331 -9.89462 -4085 4 9.36538 14.5282 36.5395 -10.4264 -5.45721 -18.9107 -4086 6 0.534978 28.7509 32.1461 -15.0727 14.1973 -4.1115 -4087 4 0.468283 29.1163 31.2513 -2.72678 6.96628 5.64212 -4088 4 0.834469 27.866 31.9601 7.81775 -11.1437 7.49829 -4089 6 26.1375 14.1816 40.8286 20.1166 -40.7048 30.4826 -4090 4 26.3241 13.5573 41.5993 3.0023 20.8863 -27.3959 -4091 4 25.2151 14.3343 40.9319 -22.5068 13.4131 -3.44564 -4092 6 38.0468 1.72227 37.358 -19.6589 11.4537 -4.22791 -4093 4 38.2764 1.77906 36.4154 -1.14244 -2.14966 7.97792 -4094 4 37.182 2.20858 37.4052 20.9639 -13.8426 2.93072 -4095 6 43.3928 21.0193 0.385094 -33.4221 -4.11839 13.5226 -4096 4 43.2305 21.8771 0.864972 20.5484 -13.2955 -16.2126 -4097 4 44.243 20.9573 41.8451 7.78799 18.4844 3.58779 -4098 6 29.7343 12.3918 17.0888 -10.4088 14.6249 -44.7733 -4099 4 30.3573 13.1084 17.3121 -1.69191 -12.5137 15.8564 -4100 4 29.5365 11.7717 17.7855 9.28071 1.18848 24.195 -4101 6 21.0845 11.002 35.643 19.2467 11.9534 29.728 -4102 4 20.8387 11.9292 35.5336 -5.23529 -0.657509 -1.91086 -4103 4 20.6782 10.509 34.9529 -15.7216 -13.7754 -25.5995 -4104 6 24.3584 22.1274 17.054 -19.116 4.6391 -13.6617 -4105 4 24.8062 22.8618 16.6504 0.246813 15.5697 -7.02352 -4106 4 25.0581 21.6899 17.4914 19.3443 -19.237 19.9016 -4107 6 44.2632 9.62803 6.15095 12.4515 -7.11379 4.41615 -4108 4 44.6939 9.46248 5.31272 4.1824 -3.3463 -6.13814 -4109 4 43.3875 9.94101 5.94426 -13.441 6.05535 2.74078 -4110 6 40.7983 2.89203 6.29118 6.30341 -5.06299 2.94692 -4111 4 40.283 3.08384 7.0886 -2.93464 8.08246 -11.2803 -4112 4 40.6425 3.53992 5.58152 -5.48248 3.30556 7.46891 -4113 6 23.4927 29.787 25.2074 -17.9847 -14.6764 23.1638 -4114 4 22.9663 29.9524 24.4255 0.505661 2.84572 -7.25135 -4115 4 24.3189 30.243 25.1366 19.4862 15.0746 -12.06 -4116 6 45.2253 20.6067 7.48804 -4.5495 -5.9569 -0.737791 -4117 4 44.4771 20.6075 6.85512 7.98227 -4.73543 5.3389 -4118 4 45.4897 19.6858 7.65762 -3.7219 7.49041 -4.48952 -4119 6 44.1869 26.5802 16.6604 -2.53584 -23.4697 22.3036 -4120 4 44.4278 26.4187 15.7655 11.491 9.41288 -34.0672 -4121 4 43.9629 25.6676 16.9 -3.51956 3.82806 13.7521 -4122 6 23.5847 27.0608 18.0875 4.92857 -1.63386 -8.1099 -4123 4 23.1417 26.2886 17.6568 -1.85204 16.5134 12.3838 -4124 4 22.9956 27.5067 18.7318 1.2523 -15.787 -12.8337 -4125 6 45.1423 16.1006 8.91925 -12.5826 4.07054 -12.5551 -4126 4 44.1756 16.0018 8.7625 13.8686 2.25455 7.61002 -4127 4 45.2849 15.9649 9.86163 -1.87368 -3.25302 7.37304 -4128 6 39.0195 15.168 5.20911 22.9796 -5.95468 -13.3261 -4129 4 39.8169 15.5451 4.76197 -16.8333 -0.501818 4.44847 -4130 4 38.2997 15.7872 5.12886 -6.79784 14.0419 -3.1922 -4131 6 40.4728 4.77172 20.098 -25.5728 -7.96759 5.38455 -4132 4 41.2852 4.73631 19.62 25.1414 0.345713 -9.53623 -4133 4 40.6586 5.20983 20.9254 2.90807 4.2574 9.49937 -4134 6 35.8334 28.4358 39.8978 -29.6544 -30.7382 0.627816 -4135 4 35.064 27.7738 39.8775 30.8234 30.4338 1.60118 -4136 4 36.4992 28.0138 39.3349 2.0747 -0.608826 -0.916217 -4137 6 26.5626 3.56604 2.67563 -12.8067 -1.70274 -2.52813 -4138 4 26.0244 3.493 1.8476 6.72613 8.7381 24.6483 -4139 4 26.0719 4.09981 3.36162 5.66066 -13.1585 -23.5937 -4140 6 2.95645 21.6514 17.6824 -3.82104 6.40043 0.291571 -4141 4 2.91294 22.1823 18.4797 -6.37673 0.600795 10.7096 -4142 4 3.68258 22.033 17.1814 1.62588 2.51689 -6.09233 -4143 6 12.886 25.0591 25.9256 19.9254 19.7817 -8.37483 -4144 4 13.3104 25.904 25.618 -13.2675 -16.998 3.60223 -4145 4 12.0452 24.9678 25.4656 -4.65807 1.85418 -5.64346 -4146 6 41.5793 20.6554 14.1751 9.92193 3.46069 0.25892 -4147 4 42.3122 20.2044 13.7523 0.767115 -12.7084 -7.64783 -4148 4 41.9959 21.4893 14.4245 -8.84771 2.34114 1.73285 -4149 6 1.24495 39.6039 11.5378 16.0363 -42.6363 3.17437 -4150 4 1.64626 38.7705 11.134 -18.3255 36.4754 4.46196 -4151 4 1.41802 39.4632 12.4909 -5.9615 12.3362 -8.98123 -4152 6 16.0218 39.0109 34.0619 -0.331369 12.6721 -5.4452 -4153 4 15.5475 38.1996 33.7806 5.75571 19.7523 -4.5346 -4154 4 15.9899 39.7855 33.4251 -7.29137 -28.599 9.21448 -4155 6 20.567 7.02475 25.5588 2.3848 7.82756 -0.6535 -4156 4 20.909 7.86076 25.1782 -7.45606 -9.2474 3.61042 -4157 4 19.6275 6.99553 25.3185 5.42042 5.25175 -3.5088 -4158 6 45.1928 25.5902 39.1787 -21.925 2.17874 18.9559 -4159 4 45.8631 26.0435 38.6892 20.8233 13.1115 -15.3132 -4160 4 45.3324 24.6675 39.0115 4.42968 -17.7425 -2.36405 -4161 6 19.9342 40.1138 28.2835 12.5964 -14.0671 -7.25792 -4162 4 19.0067 40.1593 28.0096 1.46425 5.68018 7.52545 -4163 4 20.128 40.8224 28.917 -7.48392 0.334406 -3.99949 -4164 6 26.4878 14.2069 27.3684 6.98603 -7.23951 -28.1548 -4165 4 25.5412 14.1932 27.2537 -20.7302 0.754551 -2.34698 -4166 4 26.606 14.4537 28.2745 0.836708 4.29804 26.5652 -4167 6 51.3489 25.9487 3.45136 10.7849 20.7191 -13.686 -4168 4 51.0453 25.2386 4.01334 -1.8549 -15.8565 1.21982 -4169 4 51.853 25.5737 2.69356 -6.32678 0.0553236 13.0587 -4170 6 20.1633 26.1247 2.67289 8.83438 -16.1267 5.68002 -4171 4 20.5345 25.2411 2.88723 -1.43181 13.9101 -1.64203 -4172 4 19.9438 26.1088 1.72974 -0.778515 0.427063 3.21599 -4173 6 3.13549 11.9681 27.2232 16.3616 22.3682 9.86323 -4174 4 2.68005 12.663 26.7181 4.92926 -3.58697 -0.471129 -4175 4 3.70389 12.4466 27.8862 -15.0224 -10.9098 -14.9284 -4176 6 30.1793 26.3687 4.00051 28.7119 -30.2966 58.1206 -4177 4 30.7801 25.8341 3.46925 -1.584 2.83444 -17.1702 -4178 4 29.6371 26.9341 3.51662 -25.563 30.6813 -37.7958 -4179 6 19.3205 20.6733 30.5441 -31.721 -6.25106 8.6959 -4180 4 19.1895 21.5008 31.0287 11.509 1.10551 -1.6952 -4181 4 20.2026 20.5869 30.2 22.6938 9.52703 -0.947482 -4182 6 13.5381 36.2475 0.344803 0.685356 24.2985 -17.2657 -4183 4 13.9232 37.1122 0.0997808 14.0363 -10.2996 17.9143 -4184 4 12.867 36.2368 41.5779 -17.3214 -19.7281 -1.62589 -4185 6 13.6931 21.7661 35.9637 -11.3229 -11.9655 -19.5688 -4186 4 13.4645 21.416 35.0694 1.68887 6.71419 14.5774 -4187 4 14.5559 22.1488 35.8465 12.3178 6.48213 0.887249 -4188 6 39.4176 1.76287 25.342 34.0854 -16.9064 9.57103 -4189 4 40.0026 2.33061 25.8435 -14.6367 28.4588 7.32056 -4190 4 40.0689 1.04185 25.2643 -19.5027 -7.65211 -10.5764 -4191 6 18.2964 6.13492 35.8264 -1.82227 -5.92686 -23.3299 -4192 4 18.1639 5.26767 36.254 2.04199 12.8657 6.45456 -4193 4 18.4232 6.85005 36.4651 0.375802 -9.94466 7.47089 -4194 6 2.53148 24.639 10.0969 -49.4669 34.6161 -0.50772 -4195 4 3.3243 24.1433 10.0889 43.7683 -7.59463 9.24933 -4196 4 2.65209 25.5465 10.4987 14.0059 -27.2835 -7.72375 -4197 6 35.8204 9.94567 1.34298 17.6587 14.9905 11.506 -4198 4 36.311 10.4135 0.64327 -4.10869 -3.12473 7.53129 -4199 4 36.1923 10.315 2.19711 -13.0886 -16.0695 -26.9686 -4200 6 29.0171 17.933 41.5847 -7.4648 10.4738 41.1296 -4201 4 28.4325 17.2741 41.1888 4.90819 -0.226834 -17.309 -4202 4 29.634 18.3354 40.9804 6.59061 1.40283 -25.0927 -4203 6 46.0097 27.0807 25.8707 -17.7195 2.90801 -6.40423 -4204 4 46.7639 26.9189 26.4445 5.86789 -6.79057 7.62258 -4205 4 45.3727 26.3443 25.9794 8.73043 2.74283 1.98831 -4206 6 28.1087 10.6569 35.9055 -15.3417 -26.5964 -30.9314 -4207 4 27.3182 11.0018 35.4375 11.5227 2.30745 10.116 -4208 4 28.4572 11.2922 36.5111 4.26863 23.9808 15.1461 -4209 6 25.95 20.1976 24.7821 3.31321 9.63686 -4.79579 -4210 4 26.7637 20.7132 24.6155 -9.40037 -7.04512 10.7501 -4211 4 25.7749 20.1865 25.7378 6.19451 4.49283 1.81458 -4212 6 32.2481 30.2487 10.2005 -0.567171 -33.888 25.4585 -4213 4 32.5217 30.8918 9.54162 14.407 -2.03846 -6.18424 -4214 4 32.9483 29.5597 10.4163 -8.30199 27.6945 -16.8968 -4215 6 5.04696 34.3919 23.8165 18.9071 9.10073 -2.65681 -4216 4 5.8517 34.9395 23.7378 -5.43375 -12.4066 7.00495 -4217 4 4.47737 34.8578 23.2154 -15.6684 -1.23826 -5.97721 -4218 6 29.6446 34.9396 23.1073 8.37026 13.2143 1.46186 -4219 4 30.146 35.227 23.8877 -4.79805 -2.96005 -2.8646 -4220 4 29.6355 33.9874 23.1398 -0.169507 -13.2925 4.62646 -4221 6 52.2021 25.2197 36.2484 0.203165 -13.9358 18.8619 -4222 4 51.9199 25.3821 37.1814 5.20177 -0.668093 -22.6011 -4223 4 52.2823 24.2449 36.2046 0.468647 8.20491 -0.432122 -4224 6 6.9564 41.2598 14.9786 17.963 -12.3423 -19.5336 -4225 4 7.05881 41.0384 15.8913 -5.14113 -1.34859 16.0369 -4226 4 7.66895 40.7276 14.5577 -14.5347 12.9973 2.09466 -4227 6 27.6566 39.1405 4.67566 -15.1179 -12.1251 22.0677 -4228 4 26.8424 38.6352 4.89635 10.0979 9.09612 -9.05456 -4229 4 28.2356 39.0161 5.44259 -0.0995191 -2.46215 -4.35417 -4230 6 44.4488 15.8848 30.3925 -17.4686 4.63448 -32.2897 -4231 4 43.6243 16.41 30.3099 13.0937 -10.0294 9.08699 -4232 4 44.649 15.6212 29.457 1.77951 4.94888 23.2191 -4233 6 27.3024 38.1054 13.0907 0.224949 -17.5042 -4.12929 -4234 4 27.6483 37.328 12.5833 -5.61487 10.2238 13.6353 -4235 4 27.1416 37.8221 14.0243 3.20236 0.189733 -16.1751 -4236 6 26.6663 32.9851 36.8362 -23.8807 -10.2072 10.655 -4237 4 27.4028 33.4987 36.5569 24.2269 11.6336 -10.1628 -4238 4 26.2735 33.5165 37.5295 -1.35435 2.25064 8.62378 -4239 6 26.3226 28.1988 31.7158 32.4613 11.5871 5.04411 -4240 4 26.7492 28.3346 30.8217 -6.54697 -0.873531 32.5908 -4241 4 26.9302 28.5068 32.4691 -17.7353 -8.90623 -33.5497 -4242 6 49.2114 35.7792 23.3295 1.46842 19.8344 9.76806 -4243 4 49.8184 36.2235 23.9243 -3.28067 3.63886 4.6357 -4244 4 49.746 35.0988 22.9506 10.5329 -22.9043 -16.5919 -4245 6 44.2369 15.3613 33.5367 -0.695853 -9.37614 14.4104 -4246 4 44.9539 15.1613 32.9326 3.59625 1.2978 -8.28609 -4247 4 43.6189 15.9562 33.0977 0.720121 5.36694 -8.04858 -4248 6 16.6517 35.2697 14.032 -14.9609 -5.91625 -15.8105 -4249 4 16.8478 36.086 14.4923 5.97715 10.4369 8.21626 -4250 4 15.7311 35.3947 13.7134 15.021 -1.16653 5.16189 -4251 6 45.2991 21.4701 12.0564 -47.5016 11.1637 19.3857 -4252 4 45.9844 21.105 11.5386 20.9258 -26.0087 -22.2564 -4253 4 44.5936 20.7913 12.2178 25.8967 12.3347 -6.55717 -4254 6 51.6438 5.33792 20.1099 7.42219 12.4384 36.9688 -4255 4 51.7517 5.79258 20.9932 -2.42789 -17.2577 -23.3969 -4256 4 50.9203 5.81642 19.7 -6.55397 4.36408 -6.3714 -4257 6 22.6153 27.305 0.955308 -12.5158 1.22245 6.52354 -4258 4 21.8819 27.8542 1.31405 9.62632 -7.19502 -8.89748 -4259 4 23.0385 27.8458 0.276527 0.370713 4.24399 -0.0338259 -4260 6 46.8868 12.1467 22.3289 10.3551 9.03073 -1.70047 -4261 4 46.473 12.5446 21.5671 -2.12653 7.07083 -14.4911 -4262 4 46.1639 11.6922 22.7348 -15.0603 -15.1984 17.3736 -4263 6 33.7555 5.60359 25.2366 8.41588 -11.9289 0.48427 -4264 4 34.4013 5.10188 24.7086 -2.4022 4.68399 3.96997 -4265 4 33.0757 5.86414 24.6127 -5.93503 4.46215 -0.558809 -4266 6 44.2476 18.1243 27.2334 30.0322 17.9475 -5.65933 -4267 4 44.0927 18.7931 26.5253 0.465456 -9.97561 17.2792 -4268 4 45.207 18.2464 27.4768 -29.0014 -6.50023 -5.41996 -4269 6 5.27814 37.006 29.0846 -42.995 37.8911 -11.235 -4270 4 4.83357 37.8684 28.7516 22.264 -36.721 16.075 -4271 4 6.19253 37.2033 29.2507 20.6764 5.54169 3.86921 -4272 6 20.033 5.01392 38.9409 6.34377 -32.2179 -4.45843 -4273 4 19.8009 5.56625 39.6765 -4.47316 13.7366 14.9565 -4274 4 20.2948 4.14306 39.3359 -6.8578 18.535 -7.22498 -4275 6 17.9112 2.77214 33.8677 -16.6976 6.01838 23.4157 -4276 4 18.6113 3.34266 33.5322 6.18073 5.31505 -2.96417 -4277 4 17.3526 3.28629 34.5246 17.6921 -17.568 -20.3177 -4278 6 5.56788 23.3774 22.3326 -7.55986 13.5725 18.1102 -4279 4 6.25354 23.3408 21.6412 1.32241 8.57002 8.68476 -4280 4 5.72116 24.1623 22.9232 3.31135 -14.4794 -19.5174 -4281 6 12.7438 28.0244 40.0809 14.6998 26.4392 -25.8726 -4282 4 12.8099 29.0023 40.1455 -0.120572 -14.3051 2.54846 -4283 4 13.1526 27.8611 39.1965 -9.74214 -4.86635 20.6942 -4284 6 50.5283 38.8014 28.4207 -10.7676 14.1923 -1.71082 -4285 4 51.0354 39.5212 28.0559 20.7423 0.788408 -10.014 -4286 4 49.7626 39.3052 28.7255 -7.2831 -13.6434 5.52883 -4287 6 33.5501 8.21498 17.8605 -32.9279 -35.4008 39.405 -4288 4 33.9027 8.87262 17.3189 24.9798 40.0041 -36.6225 -4289 4 33.9074 7.37462 17.5752 8.43731 -7.27798 -4.46199 -4290 6 34.6457 34.7004 17.7764 -12.4293 -15.9601 -10.9704 -4291 4 35.1223 35.3606 18.2944 6.48769 -0.751965 0.253856 -4292 4 35.2388 33.9528 17.5616 -1.14344 9.31979 5.2604 -4293 6 40.7233 5.29016 23.4005 8.26322 -6.33781 10.3585 -4294 4 41.4774 4.87923 23.8731 -9.49225 7.91527 -13.3731 -4295 4 40.0307 4.6112 23.3711 2.34129 5.18948 -0.0201455 -4296 6 16.9127 27.7621 14.4682 52.6044 -4.68653 -2.89351 -4297 4 16.0711 28.1345 14.4444 -59.8378 16.6137 -1.60006 -4298 4 17.4608 28.5627 14.561 1.7801 -9.46587 0.070581 -4299 6 29.0363 14.6633 5.00698 9.76413 -9.29226 13.7719 -4300 4 29.5096 13.8001 4.93115 -9.10936 16.1071 1.03458 -4301 4 28.802 14.7746 5.95339 2.50956 -1.40994 -14.9204 -4302 6 36.8445 17.7203 5.07362 13.6951 -24.032 -28.6565 -4303 4 36.3003 18.4061 5.45056 -9.17068 14.5835 0.43155 -4304 4 36.9783 17.8862 4.10178 -4.81067 2.65881 25.6667 -4305 6 27.7152 25.5071 34.8558 20.6182 -10.3116 10.9196 -4306 4 28.4128 25.1948 35.4689 -8.51497 -1.72528 -14.7569 -4307 4 27.3626 26.2325 35.3632 -10.8781 12.0961 2.58089 -4308 6 24.7577 17.2803 18.064 -3.70908 -2.75228 5.17573 -4309 4 25.2464 17.9619 18.5343 4.21458 5.85634 1.04617 -4310 4 24.0216 17.073 18.6635 3.98676 -0.349172 -5.54229 -4311 6 30.1887 1.57939 5.82314 -15.3902 21.7461 -57.8894 -4312 4 29.5204 1.81013 6.46928 0.301846 -2.58557 7.21893 -4313 4 29.8355 2.03332 4.95505 20.4457 -28.7719 49.9963 -4314 6 37.4518 25.9014 8.44867 -40.4019 -33.5071 29.4213 -4315 4 38.3881 25.8301 8.67833 5.27698 -2.9507 2.74989 -4316 4 36.9261 25.2192 9.0364 31.48 35.4073 -33.2345 -4317 6 24.7717 7.01585 2.25321 22.1725 6.13312 -2.42992 -4318 4 25.3573 6.36243 2.67285 -8.4103 6.94319 2.38151 -4319 4 23.8861 6.6751 2.35128 -10.8992 -4.25211 1.65182 -4320 6 25.7992 38.8457 10.7505 7.22571 37.8744 -16.0906 -4321 4 26.2906 38.615 11.5103 14.31 -23.6918 34.358 -4322 4 26.1189 39.766 10.6411 -14.7913 -5.88601 -10.6141 -4323 6 0.557249 13.5851 28.1314 4.10373 25.7622 10.4527 -4324 4 0.335523 12.7734 27.7191 -4.86664 -22.4284 -15.6315 -4325 4 0.332586 13.4422 29.0593 -0.0574933 0.663208 0.855409 -4326 6 20.4027 17.1068 12.0342 -11.148 -26.8285 -23.5414 -4327 4 20.2541 17.2545 12.9674 -4.18463 -1.09026 14.619 -4328 4 19.9228 16.2663 11.7843 12.058 20.2306 8.20324 -4329 6 30.9875 7.38585 16.6706 43.1327 18.1844 -1.13431 -4330 4 31.2844 7.10043 15.7746 -9.95685 2.73348 15.1831 -4331 4 31.8198 7.8213 17.056 -34.7561 -19.1709 -8.28734 -4332 6 10.1956 5.78615 12.1691 19.1166 9.414 40.461 -4333 4 10.1305 6.30649 11.4071 -1.6074 30.0602 -42.5686 -4334 4 9.61456 5.08708 11.9844 -30.6818 -38.1141 -6.43609 -4335 6 18.4382 31.3444 24.1606 1.21336 -6.12525 2.83497 -4336 4 18.3965 30.3858 24.3134 -0.788465 1.61506 0.642095 -4337 4 18.2608 31.7571 25.0112 -0.825834 1.26386 0.0223154 -4338 6 27.8905 29.2615 29.2809 39.8074 15.5588 -29.008 -4339 4 28.4007 29.5348 28.4528 -32.3375 -5.53357 22.8869 -4340 4 28.6323 28.9656 29.8273 -8.8667 -4.73078 13.1255 -4341 6 38.3648 15.4483 29.7818 29.0993 -31.9427 29.9284 -4342 4 38.2401 14.49 30.0972 1.05022 38.774 -16.5136 -4343 4 39.2299 15.7257 30.2111 -34.0699 1.82394 -15.2271 -4344 6 21.7074 34.7851 5.58078 8.19375 -39.9271 5.99876 -4345 4 21.4944 33.8203 5.80476 0.548141 38.153 -5.97617 -4346 4 20.9458 35.3238 5.82701 -5.25279 -7.50871 2.73382 -4347 6 18.2117 16.8293 1.01571 -12.7233 9.06437 9.63769 -4348 4 17.5846 17.1799 0.363518 5.67247 -6.87112 -0.25098 -4349 4 17.8106 17.1001 1.86952 7.78128 -5.5379 -6.7416 -4350 6 43.5131 18.5098 39.3469 22.8992 -24.809 -24.744 -4351 4 42.9473 19.1501 39.756 -14.025 22.4758 -1.21679 -4352 4 43.733 18.7829 38.41 -14.2449 3.90475 27.8798 -4353 6 17.7973 10.0724 35.5497 11.3899 1.25644 -17.5776 -4354 4 17.9076 9.35875 36.1674 -1.9111 -9.85084 12.7139 -4355 4 18.4727 9.8826 34.8661 -11.1758 5.45367 7.50841 -4356 6 36.5836 30.5676 29.0795 -26.735 36.4018 -15.4516 -4357 4 36.5101 31.4618 28.6208 1.83791 -30.0083 14.6126 -4358 4 37.4767 30.2665 28.9506 20.8385 -5.81304 -4.31186 -4359 6 38.5024 35.9654 10.4302 15.5283 7.61871 55.4477 -4360 4 38.713 36.6589 11.1463 -7.3207 -22.805 -33.4203 -4361 4 38.3781 35.1576 10.9824 1.19538 10.4075 -12.7486 -4362 6 43.3976 18.7941 34.3717 -4.38817 -12.2014 30.3889 -4363 4 43.0627 18.1963 33.6763 0.988603 1.53223 14.3474 -4364 4 43.2603 18.4022 35.293 0.0857578 9.32555 -37.8245 -4365 6 11.0576 40.22 6.11206 -6.0837 -9.04747 -4.15047 -4366 4 11.6426 40.8981 6.46389 1.08734 7.77423 2.35531 -4367 4 10.1474 40.5638 6.06331 9.30243 4.06404 0.87098 -4368 6 48.3282 13.7431 24.4718 -8.87905 25.3224 16.0087 -4369 4 47.8536 13.4091 23.7195 -8.5266 -8.47545 -16.9724 -4370 4 47.8942 14.6072 24.6749 14.3726 -19.4181 -2.72093 -4371 6 1.47819 25.7805 23.7819 -0.0731812 -13.4431 -3.72387 -4372 4 0.822875 26.4404 23.4927 11.4147 5.84295 7.97453 -4373 4 2.19403 26.202 24.2849 -5.19934 9.21725 -1.17005 -4374 6 20.5754 0.0393205 21.1081 25.6075 5.05031 -17.3956 -4375 4 19.8484 0.361847 21.622 -17.4675 -5.38456 12.9096 -4376 4 20.5586 40.9849 21.0455 -11.1839 1.66381 7.6849 -4377 6 37.6642 12.8991 30.7037 -9.9457 -20.8438 -29.8221 -4378 4 37.1371 12.462 29.9889 18.2914 6.1257 8.16018 -4379 4 36.9745 13.1334 31.2979 -14.5618 11.4049 21.409 -4380 6 49.47 17.3794 9.25364 5.30826 8.19981 -9.14457 -4381 4 48.5231 17.6061 9.31556 15.6584 -1.48937 -5.70503 -4382 4 49.8852 17.9254 8.53549 -14.9109 -12.0851 17.4703 -4383 6 34.3662 5.35535 17.144 13.1974 2.57034 -29.0571 -4384 4 34.5198 5.2998 16.166 0.54303 4.43319 20.4174 -4385 4 33.4623 5.07036 17.243 -16.3394 -6.24992 8.38082 -4386 6 14.7833 27.6665 0.0728061 -6.74966 -7.64198 -7.69033 -4387 4 13.9925 27.8402 41.4242 12.1928 3.48747 9.75107 -4388 4 15.1668 28.5017 0.401621 -7.96817 -0.0208253 -5.02821 -4389 6 48.8656 15.5206 20.7458 -9.86138 0.136748 20.6241 -4390 4 49.0651 16.3952 20.4263 0.209458 6.72405 -7.85333 -4391 4 49.1204 14.8922 20.0789 6.79298 -9.16117 -16.8166 -4392 6 23.807 40.3882 20.3905 -3.398 23.5063 24.1729 -4393 4 23.5208 41.0259 21.1064 9.42377 -19.8715 -22.5683 -4394 4 24.7282 40.1652 20.6096 -6.91059 4.34471 -3.10789 -4395 6 35.1847 31.5046 13.7021 -31.0181 23.9456 -35.1619 -4396 4 34.2309 31.3725 13.4471 24.927 2.88592 7.27171 -4397 4 35.3946 30.8036 14.2945 4.95161 -20.634 19.3451 -4398 6 10.9658 9.01332 39.5058 -15.2714 21.9147 -18.395 -4399 4 10.5965 9.92979 39.4 9.97221 -25.6919 2.69722 -4400 4 11.1763 8.90125 40.4322 -2.36933 4.41176 3.08643 -4401 6 53.2091 4.88966 16.6226 -14.1926 -12.3632 -40.3028 -4402 4 53.7513 5.3458 17.242 7.58091 5.46958 35.753 -4403 4 52.4727 4.38631 17.0042 6.19997 4.37068 9.30068 -4404 6 7.84194 33.803 26.1542 28.433 15.6582 -32.2535 -4405 4 7.6241 34.0763 27.0539 6.31302 8.01731 -0.629847 -4406 4 8.43319 34.4994 25.6777 -29.4311 -29.3345 32.8186 -4407 6 31.3263 27.9445 6.27534 4.23256 -31.0286 -11.1959 -4408 4 31.9071 27.4889 6.92578 -8.71467 11.4818 -6.48617 -4409 4 31.157 27.2952 5.54778 3.06851 13.2477 11.4148 -4410 6 31.3665 2.16522 41.0549 8.67281 8.84877 18.675 -4411 4 31.764 2.22522 0.0553479 -13.0589 -8.62932 -24.7178 -4412 4 31.1679 1.24258 40.8683 -0.324156 -6.15668 4.61941 -4413 6 33.7659 4.25511 35.8987 -17.0312 -3.82062 1.06926 -4414 4 34.343 3.86214 36.5812 -9.75418 2.24627 -3.55813 -4415 4 32.8029 4.08293 36.1352 33.1171 1.27305 -1.46623 -4416 6 47.9658 16.0637 29.8469 2.67107 -7.93457 21.4822 -4417 4 48.7643 16.2814 30.3583 0.589987 0.219824 -12.8585 -4418 4 47.4335 15.6159 30.5321 -1.60863 4.8928 -15.0046 -4419 6 49.3312 10.0914 28.5924 -0.28152 -2.80953 -5.35856 -4420 4 48.5695 10.6519 28.8218 4.15282 -2.34898 -5.74021 -4421 4 49.4995 10.1231 27.6243 -2.44246 2.9592 14.5426 -4422 6 21.4058 27.7857 29.7524 8.26148 -8.5709 13.934 -4423 4 21.8935 27.2574 30.4222 -7.07544 0.199766 -18.4014 -4424 4 21.2999 28.6278 30.1835 -3.48366 18.9655 1.67033 -4425 6 11.6744 39.4982 25.8468 7.90293 7.18169 -2.58674 -4426 4 12.2285 38.7361 26.0681 1.40058 3.92388 1.36909 -4427 4 10.8023 39.1241 25.7384 -12.6269 0.672841 -0.990747 -4428 6 22.9696 39.3076 7.85132 -6.07512 -3.4122 -1.68244 -4429 4 22.2682 38.6524 7.98148 0.173976 5.86283 1.52023 -4430 4 22.7132 40.0561 8.41581 1.67877 -3.24138 -2.90234 -4431 6 42.551 35.9177 31.3369 11.821 -63.1978 11.5341 -4432 4 42.5803 35.466 30.4647 -4.4966 22.226 11.3725 -4433 4 42.4036 36.8376 31.2573 -6.84366 36.9754 -14.9488 -4434 6 33.6582 14.7374 3.97797 20.0935 -7.17859 -40.4554 -4435 4 32.8645 15.2412 4.10613 -20.5582 11.3796 6.05129 -4436 4 33.8494 14.8388 2.99484 -4.26498 -3.76663 30.6135 -4437 6 36.6985 8.59579 17.521 17.5186 -20.4505 -17.8166 -4438 4 37.2174 8.05238 16.87 -10.1577 15.2162 18.3492 -4439 4 36.2061 9.2161 16.9727 -6.85471 3.87096 1.58869 -4440 6 20.8134 32.4132 17.3224 -0.15138 -19.2041 8.32641 -4441 4 20.2101 33.0681 16.9297 -8.31182 -6.81981 10.9196 -4442 4 20.3788 31.7527 17.9441 5.10322 26.2393 -19.6477 -4443 6 20.7088 35.3183 14.0957 -11.7768 -25.3725 -13.8548 -4444 4 21.261 35.5893 13.3574 6.77827 9.37653 -4.07387 -4445 4 20.8679 35.9028 14.8214 6.04206 13.2639 9.85712 -4446 6 20.2377 2.51389 40.1721 -7.12285 -8.41588 24.6249 -4447 4 19.7963 2.31331 41.0421 14.3479 1.04867 -24.2175 -4448 4 20.7189 1.71371 39.9103 -4.456 1.41042 1.49289 -4449 6 15.0332 14.4679 0.20602 13.2809 -6.14192 -34.7112 -4450 4 15.5535 13.6508 41.8516 -13.9549 30.8146 5.37449 -4451 4 15.3124 15.2392 41.5458 -1.11857 -25.4589 11.3055 -4452 6 24.8198 37.3334 18.5262 -9.71694 12.1129 21.4379 -4453 4 24.5044 38.0178 17.9266 6.55828 0.975012 -4.85481 -4454 4 24.4839 37.6255 19.4009 7.37292 -12.3795 -13.3571 -4455 6 3.16023 27.7824 5.25746 -7.59771 -9.49442 8.09122 -4456 4 2.57386 27.9573 6.05068 26.7372 -11.3185 -11.6141 -4457 4 4.04718 27.3724 5.4685 -26.4098 5.90831 3.92345 -4458 6 37.1274 39.059 36.0582 -20.0626 39.3499 3.12364 -4459 4 37.4397 39.697 36.7497 0.155645 -22.9334 -11.3782 -4460 4 37.5741 38.2261 36.1006 18.9616 -13.4483 8.05827 -4461 6 41.3496 16.372 3.85306 -8.55617 -26.9153 -3.74777 -4462 4 41.2863 17.3336 3.84263 10.0449 1.9656 13.5452 -4463 4 42.0245 15.9886 4.46176 -7.16622 24.1057 -6.4954 -4464 6 15.5715 3.1806 35.3543 4.49903 -8.79025 -44.1337 -4465 4 15.0747 3.51322 34.5661 7.45265 -4.29831 20.3405 -4466 4 15.2394 3.62675 36.1076 -11.9729 17.6287 21.2524 -4467 6 33.1697 24.252 7.98021 17.4163 -35.2043 24.5175 -4468 4 33.373 24.4892 7.07941 -5.88693 14.0606 -13.9779 -4469 4 32.5854 24.8767 8.38373 -10.6809 23.5743 -3.02942 -4470 6 35.8792 29.7453 15.5891 -14.351 2.75051 -7.10357 -4471 4 36.7674 29.6271 15.8378 44.9858 5.9786 2.16229 -4472 4 35.4705 29.0828 16.1298 -19.5083 -3.35284 8.18061 -4473 6 17.5951 36.8258 41.8642 -13.8657 0.640745 -39.4401 -4474 4 18.0986 36.7885 0.752491 19.5286 0.61142 14.8967 -4475 4 18.204 36.9888 41.0995 -4.16013 -2.78766 23.3657 -4476 6 26.5622 4.14757 31.1303 -11.2209 -47.8968 -15.8259 -4477 4 27.2883 4.63526 31.456 28.856 27.2634 11.544 -4478 4 26.9475 3.23966 30.9928 -12.9924 23.1667 5.46977 -4479 6 31.9456 1.33308 34.4467 -12.9904 6.64728 -11.4505 -4480 4 32.8071 1.19449 34.8725 -11.0783 -3.65615 8.33208 -4481 4 31.1956 1.0725 35.0172 18.2758 0.413953 2.527 -4482 6 24.503 14.7492 2.38048 9.24208 -0.0712211 -0.802907 -4483 4 24.1928 14.0003 2.93847 14.4388 11.7071 -7.35684 -4484 4 25.4689 14.9243 2.53228 -19.8697 -9.93034 3.69906 -4485 6 25.7634 20.9148 27.525 0.946636 -0.977661 -1.30084 -4486 4 25.4997 20.5428 28.395 3.38508 9.32598 -11.7317 -4487 4 25.6529 21.8806 27.5755 0.284497 -3.23384 4.14496 -4488 6 18.1477 40.1511 30.6505 2.638 -12.7558 5.82509 -4489 4 18.5379 39.2542 30.773 0.361891 20.0487 -3.45439 -4490 4 18.8736 40.7943 30.5754 -0.793328 -5.73314 0.616918 -4491 6 46.8137 23.9108 24.5765 -6.45001 25.2139 -38.2053 -4492 4 46.156 24.4917 24.0674 25.2521 -23.4518 17.6745 -4493 4 47.3533 23.4819 23.8873 -7.92808 3.44465 4.72259 -4494 6 45.5993 22.6806 26.5072 -4.87261 3.12825 -8.14378 -4495 4 46.0946 22.9584 25.7273 -3.42504 -3.72677 5.16847 -4496 4 46.0209 23.1613 27.2227 -5.79148 -3.32105 5.25932 -4497 6 20.0977 4.47574 26.7104 -1.85738 36.2438 14.3308 -4498 4 20.3766 5.37803 26.4593 -10.8474 -9.08605 12.6513 -4499 4 20.6066 3.98633 26.1049 14.7704 -34.5311 -24.6657 -4500 6 35.268 26.6035 12.5547 25.3434 4.5593 25.1203 -4501 4 35.7054 25.7374 12.5354 -13.4481 2.49909 -6.64065 -4502 4 35.8431 27.0669 13.1929 -15.092 1.56141 -12.9558 -4503 6 3.25549 33.9664 12.2985 -21.2488 -6.99508 3.93395 -4504 4 2.30606 33.7392 12.3085 7.5225 -4.25393 -1.25154 -4505 4 3.25844 34.917 12.332 8.53638 16.5693 1.24934 -4506 6 36.6808 1.27299 25.5856 -28.051 -2.86161 17.5249 -4507 4 37.6164 1.46673 25.6835 8.21338 5.71919 3.59986 -4508 4 36.1703 1.6124 26.3685 15.6278 -2.9361 -18.4357 -4509 6 16.8737 4.664 24.0353 -31.9925 -2.01789 -27.2632 -4510 4 15.8786 4.73848 23.8401 40.5517 -2.65221 8.73903 -4511 4 17.2589 4.19458 23.2519 -3.48506 7.68373 17.7614 -4512 6 39.6701 15.0742 7.83356 -1.71206 -7.05123 2.14494 -4513 4 39.2725 14.2274 8.02711 2.44544 -9.24519 17.4119 -4514 4 39.3892 15.1326 6.9218 7.69265 14.011 -7.76766 -4515 6 9.96731 20.1909 2.92864 -13.1382 1.0323 -16.144 -4516 4 9.71565 20.5309 2.05786 3.65664 7.03968 6.64426 -4517 4 9.8995 19.2377 2.78093 4.24026 5.10291 12.3576 -4518 6 23.4077 4.6159 15.27 -3.48308 -16.1533 -1.5067 -4519 4 23.619 4.71624 14.3536 6.29203 -7.01184 -22.1313 -4520 4 23.1672 5.50294 15.4683 -4.33935 19.8524 20.6561 -4521 6 23.5267 41.6518 17.9122 -9.44104 0.807914 21.3506 -4522 4 23.7067 41.2659 18.7956 7.59245 -0.294373 -11.029 -4523 4 22.6339 0.0834245 18.0732 1.82991 3.48892 -13.1537 -4524 6 30.9316 4.82324 1.33107 45.9774 51.3713 7.99935 -4525 4 30.5768 4.02682 1.05687 -28.0042 -54.4029 -17.3695 -4526 4 31.8094 4.8761 0.879215 -15.6392 -0.833181 8.5221 -4527 6 29.2201 33.7587 18.5991 58.073 2.92721 -1.85527 -4528 4 30.1837 34.1183 18.6008 -42.2538 -17.2347 0.0641557 -4529 4 28.6837 34.5413 18.5643 -15.6262 17.5996 3.33909 -4530 6 23.1221 16.7099 3.68521 11.8431 -16.3115 0.0733348 -4531 4 23.6562 16.338 2.95547 -9.45134 2.67217 9.8165 -4532 4 23.048 17.6538 3.54099 -2.31098 6.59774 -1.54538 -4533 6 34.8961 26.7639 31.7325 -1.99602 4.46994 3.67284 -4534 4 35.0929 27.7139 31.562 -2.18198 -17.8875 -5.58085 -4535 4 35.0252 26.2302 30.9312 2.47742 18.1005 -1.54363 -4536 6 7.11189 40.7663 20.959 14.901 4.90705 15.7674 -4537 4 6.49418 40.4573 20.3006 -5.17655 -2.88906 -15.6427 -4538 4 7.9749 40.9101 20.5297 -6.61986 -3.78335 -7.15935 -4539 6 52.4451 9.69387 11.9379 -8.46192 -13.0679 -16.1645 -4540 4 52.1167 8.90553 11.4509 5.46474 18.3719 13.4625 -4541 4 53.1134 10.0871 11.3593 -6.16158 -0.354597 4.80602 -4542 6 12.0344 32.7576 27.7445 1.28323 7.36678 12.5499 -4543 4 11.2848 32.2741 27.3627 7.37999 2.33687 -5.47139 -4544 4 12.7987 32.654 27.1746 -1.40521 -5.62475 -4.84597 -4545 6 15.7821 18.5441 0.84801 8.76354 -4.35468 -11.8188 -4546 4 16.4439 18.9467 1.42581 -3.0166 1.81121 1.10538 -4547 4 14.9492 18.5892 1.29924 -12.8156 0.756803 9.02992 -4548 6 30.9925 13.9418 7.42386 -4.40747 -9.92517 -19.1249 -4549 4 31.0137 13.4754 6.53341 6.38174 17.9129 28.0089 -4550 4 31.6996 14.6103 7.52177 -5.32565 -11.3142 -7.68087 -4551 6 23.9405 39.5605 3.5435 10.8606 -6.43074 -8.73391 -4552 4 24.3095 38.7805 4.04208 -2.00396 18.4511 -18.0645 -4553 4 24.6123 39.8651 2.88148 -9.69774 -9.50421 15.8523 -4554 6 53.2462 13.9551 2.00337 -15.5118 -12.0942 -3.71099 -4555 4 54.104 14.269 2.28215 12.5804 5.35006 1.30654 -4556 4 53.0522 14.3304 1.13281 7.32968 -0.777694 2.32044 -4557 6 29.4483 26.4268 7.81741 -0.171572 11.4439 -18.4732 -4558 4 29.8672 26.7876 7.00927 -3.33338 -4.99995 18.6366 -4559 4 28.5088 26.3872 7.58736 -4.03891 -2.78124 5.15679 -4560 6 24.6251 23.6043 31.0935 -26.8137 17.7603 -44.4691 -4561 4 23.7139 23.2229 30.9355 29.773 11.0738 8.78977 -4562 4 24.7983 24.2076 30.2965 -2.98074 -30.8217 36.523 -4563 6 33.658 19.3188 40.511 -4.29932 4.0975 7.85681 -4564 4 33.8365 18.6271 41.1728 0.0947513 0.993086 -5.72158 -4565 4 34.3002 19.2334 39.7953 0.390848 -1.03282 -3.03706 -4566 6 0.558986 35.9852 14.2205 11.1667 11.0015 21.0521 -4567 4 1.21386 36.1432 14.9149 3.92292 -5.96876 -2.97707 -4568 4 0.043734 36.7876 14.3014 -15.3768 6.08493 -10.5247 -4569 6 7.05222 12.7587 15.7802 -26.1824 -15.4106 14.8382 -4570 4 6.35773 12.5373 16.4499 19.2033 7.53925 -13.5919 -4571 4 6.88557 12.0803 15.1093 4.12905 5.75416 0.888 -4572 6 7.8802 3.87979 22.4264 4.564 -30.6165 13.1651 -4573 4 7.61737 4.55637 21.8154 -5.12813 13.4305 -13.5146 -4574 4 7.59435 3.01808 22.0419 3.92228 16.9329 8.71162 -4575 6 50.747 32.0919 16.246 0.584829 29.9532 -6.88448 -4576 4 49.8575 31.8158 16.477 -3.66132 0.0213613 -0.234359 -4577 4 50.6533 33.048 15.9617 2.92819 -31.696 10.1835 -4578 6 15.3083 18.2099 30.0577 17.4273 -12.3999 25.5818 -4579 4 14.8795 18.523 29.2753 -13.2188 2.60124 -19.4058 -4580 4 14.9888 17.3027 30.2404 2.47215 8.3937 -6.40515 -4581 6 36.7253 25.4508 33.3862 -30.1432 30.6395 -17.6873 -4582 4 35.9871 25.9696 32.8546 42.334 -36.2451 27.5582 -4583 4 36.7428 24.5171 33.143 -7.68133 1.91065 -3.3758 -4584 6 16.5208 21.8449 20.262 -11.2097 8.64672 -3.63533 -4585 4 16.6085 20.9267 19.9682 1.68058 -0.497742 -2.90804 -4586 4 16.3112 22.3946 19.4823 4.36577 -8.59001 6.07269 -4587 6 44.2833 3.11948 30.0766 -7.99673 -6.73576 30.9987 -4588 4 44.2005 2.2232 29.7402 -0.794022 -7.70278 -4.62871 -4589 4 44.5183 3.67066 29.3503 7.77568 15.2131 -24.9404 -4590 6 51.0808 14.1269 27.7758 -27.047 -14.2895 -4.28411 -4591 4 51.175 15.071 27.7901 8.66575 19.7266 0.878182 -4592 4 50.1173 14.0309 27.5969 15.0189 -4.76366 3.10402 -4593 6 54.1497 15.8755 27.1203 10.9044 -5.07506 15.753 -4594 4 54.6247 15.0341 27.411 -19.35 18.5916 -21.6107 -4595 4 53.6213 15.8397 26.2863 11.6919 -13.2292 13.7718 -4596 6 26.7269 15.1716 34.5247 3.07047 6.28357 -2.56105 -4597 4 26.6547 16.15 34.5201 9.87746 -16.6036 -4.19036 -4598 4 27.4477 14.9176 33.917 -5.54963 13.4877 1.89491 -4599 6 34.6713 2.21044 27.481 35.3652 -9.42756 14.1603 -4600 4 34.3712 2.0217 28.3795 -9.10436 3.38048 -0.887416 -4601 4 33.9282 2.37922 26.9258 -24.4077 6.67858 -6.22498 -4602 6 36.3012 17.6491 40.388 5.86113 23.4658 6.44349 -4603 4 35.7206 17.1804 39.7974 -3.43874 -12.7236 -2.47465 -4604 4 36.6864 17.0408 41.0377 -6.22241 -0.114851 -7.42509 -4605 6 26.2819 0.194243 33.0916 -21.1162 -1.74839 5.89968 -4606 4 26.0541 0.792538 33.818 7.17118 8.51167 2.05738 -4607 4 25.4361 41.6393 33.0097 0.772233 -7.73624 -3.23605 -4608 6 5.19547 35.5715 31.6247 14.6733 -21.492 26.4929 -4609 4 6.10271 35.831 31.8735 -9.75028 2.17691 -1.53344 -4610 4 4.97694 36.0548 30.8519 -3.41417 18.4244 -29.6169 -4611 6 20.2195 22.0294 35.119 8.25657 -3.203 11.321 -4612 4 19.9286 21.1888 34.7559 -2.68712 -4.78598 1.15285 -4613 4 20.5567 21.7901 36.0152 -5.29706 4.10974 -20.8318 -4614 6 15.9087 36.5843 36.9399 0.69981 -30.9087 31.3945 -4615 4 16.5764 37.2836 37.0377 -3.33596 -3.14632 -1.27145 -4616 4 16.032 35.9777 37.754 -5.87689 21.7482 -34.0408 -4617 6 30.95 22.3912 3.57027 12.227 -51.3484 -20.5494 -4618 4 31.0645 22.6091 4.4902 1.82476 2.59415 19.1922 -4619 4 31.2691 21.4218 3.50648 -13.7255 40.3499 2.75328 -4620 6 47.0405 8.41049 14.2025 -7.26712 -13.7585 -23.7685 -4621 4 46.2225 8.31623 13.6472 18.9804 2.55096 13.7682 -4622 4 47.7321 7.85584 13.7597 -18.0416 11.4216 8.02226 -4623 6 34.1106 18.627 3.15563 -0.4946 23.1394 22.2065 -4624 4 34.672 18.2914 3.86301 0.996255 -3.71784 -4.49801 -4625 4 34.2399 18.1173 2.36738 0.542984 -13.2578 -17.3669 -4626 6 26.7976 25.3916 12.343 -23.6037 -44.5624 17.4882 -4627 4 27.2059 26.2338 12.4335 13.1462 29.8808 4.32264 -4628 4 26.6887 24.995 13.243 7.37483 11.5945 -21.6739 -4629 6 22.6215 25.7777 30.8835 17.9212 -8.3502 11.6983 -4630 4 23.3826 25.7056 31.4928 -6.70991 6.16838 -4.71983 -4631 4 22.2455 24.8881 30.8847 -4.10822 -0.13742 -3.2228 -4632 6 23.6315 9.78689 35.7599 5.48292 -2.30097 -0.625566 -4633 4 22.8113 10.2893 35.7248 -4.77612 1.7474 -0.383276 -4634 4 23.3643 8.87406 35.5171 2.31753 16.9109 3.97959 -4635 6 10.4044 36.7742 9.63922 -25.0741 -4.1625 3.51028 -4636 4 9.48479 36.4361 9.55892 17.1497 7.1291 1.06445 -4637 4 10.7029 36.9295 8.73946 3.49181 4.27039 -8.54773 -4638 6 4.00239 32.4234 25.8687 17.3833 10.7639 11.9139 -4639 4 4.35688 32.9952 25.1699 -1.7627 -0.965582 -1.95819 -4640 4 3.3252 31.8731 25.4905 -12.2764 -14.2405 -10.2138 -4641 6 29.0717 26.0252 18.6551 27.2015 -27.7815 2.54409 -4642 4 28.1485 25.9947 18.9226 -9.28828 -8.18845 2.68073 -4643 4 29.5616 25.1801 18.9271 -24.0321 31.3207 -7.4501 -4644 6 15.3034 1.33037 27.9713 -8.15532 13.2931 -1.88459 -4645 4 14.9824 0.900448 27.1643 -4.10476 8.37726 9.18093 -4646 4 14.8435 2.19317 28.1161 8.64797 -17.4448 -9.70896 -4647 6 48.6122 2.88813 22.9601 -14.0575 20.6462 10.9468 -4648 4 48.3097 2.01316 22.7294 4.97712 -8.72373 -1.92059 -4649 4 49.4728 3.0448 22.5739 5.56154 -9.57595 -10.4155 -4650 6 53.0134 0.348391 19.7218 2.72624 -2.60203 -3.14968 -4651 4 52.5877 42.0257 20.5538 -0.625041 0.289898 3.74318 -4652 4 52.305 0.305612 19.0628 -0.905041 -0.864478 -1.55308 -4653 6 1.39118 17.4858 17.9447 -8.50794 14.6458 12.7327 -4654 4 1.24353 17.4779 16.9894 -1.31782 -10.0732 -1.96873 -4655 4 1.47925 16.6123 18.3551 -1.8326 -9.29856 -10.4725 -4656 6 37.8975 19.0277 37.6053 -28.6618 15.029 -11.7184 -4657 4 36.9647 18.7897 37.7838 11.6122 1.96204 1.16191 -4658 4 38.4406 18.4447 38.1174 10.3965 -16.3488 12.6679 -4659 6 26.9855 30.3558 38.071 9.50079 1.40194 -4.36533 -4660 4 26.0886 30.216 37.7369 5.39533 7.19535 -1.12484 -4661 4 27.2954 31.2276 37.7499 -13.0308 -11.5285 -0.168161 -4662 6 20.0885 18.5747 3.04679 -6.02291 21.5949 -15.2672 -4663 4 19.9787 17.7407 3.50085 7.53739 -11.7285 12.3408 -4664 4 20.8981 19.0299 3.33477 -4.38138 -14.9723 0.744253 -4665 6 35.0861 6.94018 4.08702 3.04221 -3.62035 -0.583554 -4666 4 35.6351 7.18342 3.33325 6.4301 -2.1748 -2.62446 -4667 4 34.2564 7.39563 3.93984 -10.6534 0.652929 2.2495 -4668 6 22.2213 37.08 31.2556 -28.1532 13.1327 42.6182 -4669 4 22.1563 36.8958 30.3458 -2.68084 -5.78815 -35.014 -4670 4 21.2899 37.3194 31.5407 35.2494 -6.03647 -12.8067 -4671 6 12.3954 22.364 41.8234 21.4337 26.9075 -8.21443 -4672 4 12.9612 23.1595 41.5956 -22.2624 -27.6618 12.5485 -4673 4 11.7092 22.295 41.1522 0.74395 2.83494 0.343647 -4674 6 43.2331 30.3213 23.157 26.8689 32.5799 1.85734 -4675 4 44.1495 30.0558 22.8796 -21.7207 5.89602 6.32158 -4676 4 43.3514 31.2801 23.4416 -6.45211 -30.9956 -6.78246 -4677 6 16.5257 8.07813 16.6617 -19.4309 -12.5216 11.6481 -4678 4 16.3886 8.34983 15.7476 7.00958 2.01583 -5.14722 -4679 4 17.4107 8.32004 16.9428 8.9294 8.4681 -2.86418 -4680 6 10.0506 8.65043 31.7756 -2.39508 10.2278 -10.4865 -4681 4 10.14 7.97578 32.4103 1.95442 -36.8206 12.1998 -4682 4 10.116 9.39125 32.3649 -0.107045 27.388 0.472024 -4683 6 10.1509 6.49695 25.6483 14.6726 -6.33183 2.00995 -4684 4 9.37694 6.15153 26.0805 -12.3653 -8.75157 5.1154 -4685 4 9.82248 7.1865 25.0601 3.70088 -0.958502 2.30736 -4686 6 49.8668 7.2369 25.5225 -24.0329 9.97804 -6.35029 -4687 4 50.053 6.31696 25.3599 8.14544 -13.6468 -2.92498 -4688 4 50.6696 7.6642 25.7982 18.0374 4.82749 5.17198 -4689 6 18.4641 37.5693 33.932 -1.74635 9.46172 -1.89257 -4690 4 17.7617 38.2474 34.0853 10.1616 -18.2299 -3.47398 -4691 4 18.0542 36.6946 34.0238 -8.30855 4.53024 1.19921 -4692 6 32.1897 34.7964 39.2558 32.2313 -17.5381 13.0656 -4693 4 32.48 34.3381 40.0896 -7.23509 10.7133 -18.5379 -4694 4 31.2879 35.0284 39.3813 -31.6037 5.0658 8.82 -4695 6 49.5304 23.9104 4.45569 25.8701 3.67026 -38.321 -4696 4 49.7808 23.1947 5.01942 4.2809 -18.8946 17.0996 -4697 4 48.8132 24.3493 4.85794 -31.8244 16.1567 21.064 -4698 6 6.0606 24.4992 33.9345 -0.638471 -2.64646 7.7036 -4699 4 6.7001 23.7849 33.7997 2.17947 5.97399 -8.00372 -4700 4 5.47521 24.1274 34.6146 -0.567039 8.82042 -5.77933 -4701 6 1.71497 22.9937 24.1827 2.23241 21.1509 -1.27791 -4702 4 1.62302 23.9425 23.95 -0.486435 -10.8617 3.92094 -4703 4 0.825214 22.7289 24.4403 -5.44701 -4.12175 2.39318 -4704 6 12.4657 16.5565 32.3481 -44.3953 42.3465 -23.9812 -4705 4 13.2256 16.0186 32.4214 25.6927 -27.9273 24.4997 -4706 4 11.8347 16.6394 33.1026 23.5286 -12.3088 -0.369419 -4707 6 21.3722 37.3857 27.9432 8.33623 1.67622 30.3175 -4708 4 21.2745 37.3852 27.0022 -8.47587 6.30229 -26.1478 -4709 4 20.7646 38.0573 28.2974 0.343549 -1.37388 -6.67046 -4710 6 27.2371 40.835 28.8059 -14.5618 2.70883 26.0148 -4711 4 26.5104 41.4636 28.9519 7.17104 -1.72995 -14.6333 -4712 4 27.2442 40.3637 29.6524 5.83721 -3.62297 -8.28664 -4713 6 0.999535 21.7321 13.5318 -29.3194 4.17708 -0.571391 -4714 4 1.85706 21.6318 13.8745 50.1621 -4.04822 5.83187 -4715 4 0.493313 21.4968 14.3164 -12.4374 2.61082 -2.41507 -4716 6 22.3196 2.57547 8.74609 19.5097 -5.43411 17.7027 -4717 4 22.9517 3.10624 8.26305 13.4452 6.72454 -0.92593 -4718 4 21.5477 2.63817 8.2102 -22.9662 -0.14239 -10.9727 -4719 6 29.9886 17.8486 8.24374 -1.93571 4.49032 -2.67939 -4720 4 29.0601 17.6146 8.32603 -5.42798 -1.41354 1.1127 -4721 4 30.4131 17.4547 9.01282 4.29332 -3.23535 5.29369 -4722 6 3.62824 37.7086 25.7053 -21.3362 8.32154 -6.60892 -4723 4 4.42904 37.184 25.8405 -4.94962 -9.47676 -0.42012 -4724 4 2.83762 37.1591 25.4673 21.6133 3.65171 5.88982 -4725 6 26.7972 27.6476 36.3581 -47.4115 -5.5291 12.7506 -4726 4 26.8465 28.2624 35.6306 8.29087 8.74477 -10.4705 -4727 4 25.8218 27.6191 36.6005 30.1762 -0.597939 -6.56813 -4728 6 13.3509 25.3111 38.1214 6.90903 -15.9492 13.2692 -4729 4 13.3459 24.3911 38.4732 0.919555 17.3618 -5.73458 -4730 4 14.144 25.7168 38.5298 -8.43807 -1.25323 -5.48633 -4731 6 49.7161 27.2636 6.73274 -18.8339 5.2299 -32.7408 -4732 4 49.5935 26.3653 6.40806 5.58405 -0.645115 8.82912 -4733 4 49.2001 27.7791 6.04852 15.3529 -4.94049 26.886 -4734 6 39.7451 11.5811 10.2076 8.75523 -9.51322 -11.6408 -4735 4 40.371 10.9447 9.80262 -5.32314 14.1891 9.76509 -4736 4 39.1233 11.799 9.49079 2.50191 2.43793 7.76023 -4737 6 17.4883 24.9894 35.5591 -19.4762 1.01983 7.35275 -4738 4 17.0975 24.7887 34.694 2.72786 0.423626 1.28381 -4739 4 18.4353 24.8575 35.5073 10.004 -2.92602 -7.93295 -4740 6 45.0832 34.9807 31.8277 24.5651 -3.79623 6.38158 -4741 4 44.3095 35.5111 32.0501 -8.6141 -4.27399 -12.5931 -4742 4 44.9123 34.3632 31.1055 -12.5508 0.508806 -0.453023 -4743 6 30.2187 9.89463 31.3271 7.05348 4.55507 6.68413 -4744 4 30.4541 10.7656 30.9635 -3.12777 -8.04008 8.45875 -4745 4 30.1355 10.0083 32.293 1.90576 1.32601 -8.54322 -4746 6 32.3712 9.2149 6.61373 28.8381 -35.7198 -39.9492 -4747 4 32.1726 8.66567 5.78496 5.01502 20.0116 29.9298 -4748 4 31.5547 9.49954 6.96481 -36.3246 12.521 14.22 -4749 6 9.26959 24.9556 35.9161 1.96832 15.842 -17.2096 -4750 4 8.91298 25.4858 35.1726 -0.127744 -15.1166 11.0351 -4751 4 9.85583 25.5957 36.3463 -2.24606 -10.0757 2.02076 -4752 6 40.3298 1.49261 18.8755 10.6299 1.30292 -21.7 -4753 4 39.6194 1.80532 19.3944 -35.8146 17.5344 12.5449 -4754 4 40.7796 0.936194 19.4956 21.1502 -18.4862 6.40423 -4755 6 5.26901 10.6323 30.4328 -1.07618 -0.575959 25.8078 -4756 4 5.0059 11.4532 29.9824 1.00544 3.53991 6.4134 -4757 4 5.36238 10.8297 31.4225 -4.75078 2.46468 -31.0333 -4758 6 25.6472 11.7043 25.6564 -2.85241 -30.912 5.54365 -4759 4 25.9319 12.4737 26.1319 5.23872 14.1859 6.15637 -4760 4 25.9893 10.9537 26.204 -5.41829 19.961 -14.7301 -4761 6 21.91 20.0664 29.7913 -6.2328 1.4725 0.460556 -4762 4 22.5319 20.0532 30.5545 -13.0709 -9.05965 -9.53591 -4763 4 21.5487 19.1817 29.5606 11.8355 8.09924 7.60661 -4764 6 10.008 19.9919 34.5046 11.2891 -12.0839 -11.2138 -4765 4 9.40296 20.4589 35.0806 -5.60052 -0.834193 8.04722 -4766 4 10.0208 19.0442 34.745 -1.06298 11.667 -2.12072 -4767 6 24.6334 10.3662 12.209 5.25257 18.8662 20.0118 -4768 4 24.6941 9.47775 12.5956 1.57271 8.96717 -2.9517 -4769 4 24.9719 11.0034 12.9045 -11.2568 -27.0384 -15.8586 -4770 6 50.4496 28.283 11.5446 48.5969 7.21476 -25.6728 -4771 4 51.3012 28.7385 11.2434 -32.0883 -19.6524 11.3949 -4772 4 50.1145 28.8771 12.2081 -10.2548 6.02908 11.3498 -4773 6 13.9159 27.6234 25.0588 -25.6331 11.4059 -15.4978 -4774 4 13.5005 28.0493 25.83 5.93925 -3.01588 -8.8098 -4775 4 13.4276 28.0022 24.2718 14.6036 -12.4854 23.8457 -4776 6 46.1589 18.6653 40.4078 -23.2184 -0.389309 -10.7846 -4777 4 45.2349 18.5626 40.0761 15.1795 0.391647 5.46432 -4778 4 46.2048 19.5984 40.6658 -0.558864 -5.77386 -4.91212 -4779 6 32.4746 14.176 27.1227 -16.003 2.1806 5.505 -4780 4 31.9042 13.6172 27.6867 7.52463 5.83279 -7.70325 -4781 4 32.1655 15.0897 27.2802 4.78128 -6.53963 -2.41902 -4782 6 14.0556 36.3553 13.3828 19.8073 6.5728 22.6139 -4783 4 14.1017 37.3298 13.5875 -14.1879 -23.5484 -13.1576 -4784 4 13.3212 36.1206 12.8052 -8.41953 14.8686 -5.40295 -4785 6 1.88392 36.5802 21.9963 -4.52806 -9.18778 1.34501 -4786 4 1.78058 36.5165 22.9531 -3.13652 -1.22736 7.08711 -4787 4 2.81062 36.8013 21.8509 3.08344 1.49572 -0.20158 -4788 6 25.283 31.8665 39.7486 -0.0346121 -4.3463 21.3102 -4789 4 24.9491 32.7147 39.4474 -1.97702 6.83441 1.95234 -4790 4 25.5262 31.9404 40.7015 -5.12155 2.92558 -20.0537 -4791 6 6.47988 22.0137 1.28428 -12.6715 -7.61279 -4.66874 -4792 4 5.53909 21.8738 1.48571 10.6555 3.73696 2.93659 -4793 4 6.5727 22.8978 0.916948 1.0061 5.37498 -0.183021 -4794 6 27.6236 25.0404 4.70626 6.00578 18.2896 15.2827 -4795 4 28.5331 25.4118 4.61276 -17.9968 -6.47987 4.19831 -4796 4 27.2352 25.3966 5.54825 13.7859 -6.49357 -18.8943 -4797 6 21.6401 30.9371 41.2305 6.69834 21.9548 -27.1087 -4798 4 21.276 30.3289 41.855 -17.7491 -18.0709 13.8774 -4799 4 21.0024 31.0127 40.4783 8.64888 -5.56942 17.5854 -4800 6 32.355 18.8729 12.7674 13.4209 4.31066 2.75957 -4801 4 31.3956 18.9706 12.835 4.55688 -5.10905 -10.5867 -4802 4 32.607 18.5493 11.8826 -7.53687 3.28724 6.30822 -4803 6 35.6452 19.4617 21.1556 -9.82604 19.2175 8.60555 -4804 4 35.3405 18.5718 21.3708 -2.26659 -3.59924 -3.4629 -4805 4 34.936 20.0876 21.4701 16.8427 -19.1907 -7.36791 -4806 6 27.6904 17.9595 34.0135 2.51947 12.848 9.8691 -4807 4 28.1207 18.371 33.2456 -3.55582 0.0466306 5.59907 -4808 4 28.0719 18.4525 34.7708 -4.77519 -7.99763 -12.3529 -4809 6 34.1913 39.0308 14.8198 -32.2909 7.81486 42.3772 -4810 4 33.7378 38.3849 14.2709 2.40292 -0.641653 -5.60016 -4811 4 33.4938 39.1934 15.5434 31.6198 -1.67931 -26.5413 -4812 6 28.5078 3.47132 33.888 -4.80695 9.04662 2.15546 -4813 4 27.9441 4.2497 33.8725 -11.1427 -2.20885 -1.07295 -4814 4 29.3801 3.85895 33.8332 18.6007 -6.2612 -1.20104 -4815 6 34.9259 32.1312 6.54177 -41.0464 -12.9808 21.9467 -4816 4 34.0171 32.0297 6.98271 38.7419 4.2921 -24.6555 -4817 4 35.5211 32.1736 7.29951 5.76537 -1.35874 -3.25655 -4818 6 31.8896 6.8799 23.5232 0.89208 3.44668 5.58958 -4819 4 32.4231 6.58347 22.7679 -0.16899 1.4285 3.8543 -4820 4 32.2407 7.75715 23.7826 1.29066 -6.24882 -6.25814 -4821 6 18.8559 1.76458 0.828337 -20.5472 23.3683 -17.7838 -4822 4 18.0266 2.11952 0.42761 13.2396 -12.575 3.84382 -4823 4 19.0445 2.38904 1.53279 3.18086 -1.81057 9.578 -4824 6 26.9929 18.9294 11.856 68.8676 -4.65359 -28.5611 -4825 4 27.3133 19.7685 11.4551 -15.5879 -7.28987 7.59546 -4826 4 26.1136 18.988 12.1267 -55.7646 13.8464 15.3945 -4827 6 43.8351 11.1458 18.4443 23.0031 -19.5153 4.50837 -4828 4 43.638 10.8812 17.5537 -13.1544 4.18059 -17.1583 -4829 4 44.5589 10.5175 18.6246 -1.75483 13.9327 9.72942 -4830 6 33.4946 40.5615 37.6755 15.4013 8.76106 -9.33396 -4831 4 34.0096 40.2689 38.4502 -12.4229 -1.46966 -1.83753 -4832 4 32.5786 40.2698 37.7667 -1.95229 -4.85928 9.55413 -4833 6 15.6186 26.7023 39.419 -29.2453 -49.1617 7.39509 -4834 4 15.4971 26.9949 40.3155 1.17426 12.5786 14.7177 -4835 4 16.1446 27.3092 38.9602 29.5915 33.502 -22.8309 -4836 6 4.38071 13.8775 40.883 9.27553 -14.126 -4.37485 -4837 4 5.31782 13.6454 41.0342 -11.8393 4.50398 0.960258 -4838 4 4.04834 13.2497 40.2173 2.13772 10.7877 7.68198 -4839 6 20.1656 10.4005 38.218 10.8779 4.82467 -13.4554 -4840 4 20.4848 10.7245 37.3555 -10.2589 -5.36296 0.708096 -4841 4 20.9923 10.2607 38.6798 -1.28838 -2.71386 11.844 -4842 6 15.1666 19.24 23.8849 4.49083 -8.21488 3.46045 -4843 4 15.3253 20.1347 24.2296 -1.0797 -1.90309 -4.08137 -4844 4 15.0239 19.3391 22.9299 0.969961 5.53483 11.956 -4845 6 47.8934 28.614 15.7995 12.3109 16.1315 8.54118 -4846 4 47.9523 27.7003 15.5425 0.10403 -15.196 -3.00888 -4847 4 48.6265 28.752 16.4246 -6.57835 -5.21115 -6.70139 -4848 6 29.9259 30.9075 18.965 7.62461 4.23841 -1.37457 -4849 4 29.1117 30.4308 18.7732 -7.06282 -5.88302 -2.4339 -4850 4 29.7134 31.8391 18.8515 -2.57834 1.4724 1.74445 -4851 6 11.9338 35.8178 28.497 -7.27451 6.14295 -10.3733 -4852 4 12.5041 35.9802 29.2427 6.70347 11.4983 16.16 -4853 4 12.1847 34.9375 28.2428 -3.53576 -18.0038 -9.26428 -4854 6 29.972 37.8772 25.486 -12.1052 4.73031 -22.3992 -4855 4 30.2553 36.9663 25.6711 3.40868 8.54106 4.83275 -4856 4 30.3747 38.5051 26.0898 8.03536 -1.45294 10.6494 -4857 6 52.6584 28.1048 32.275 31.4311 4.91254 4.04956 -4858 4 52.2473 28.8547 31.8392 -9.38068 2.35947 -3.12986 -4859 4 53.5924 28.4001 32.3224 -6.05351 -9.99886 1.81474 -4860 6 37.0156 40.0823 11.982 15.2095 -8.99172 -8.52195 -4861 4 36.22 40.5624 12.1833 -15.2617 4.79593 6.40041 -4862 4 37.4101 39.8767 12.8402 0.665617 -0.484924 4.09883 -4863 6 16.6662 16.7824 36.4899 -23.6543 20.4081 -13.3107 -4864 4 16.0299 17.4889 36.7962 20.061 -22.8424 -10.9222 -4865 4 16.728 16.9177 35.5139 -3.3638 -0.555369 18.7216 -4866 6 27.9984 4.17668 38.8431 -6.8633 -1.77316 4.22536 -4867 4 28.9161 4.3061 39.1095 4.06977 1.67187 2.70396 -4868 4 28.0368 3.69267 38.0106 -3.95018 -5.40445 -5.6405 -4869 6 28.9057 0.266004 17.7212 -6.10073 29.2375 -5.44551 -4870 4 28.1786 0.88303 17.5246 8.92385 1.95552 -1.67076 -4871 4 28.4447 41.3635 17.8399 -11.0591 -30.1495 5.35559 -4872 6 22.9291 20.1009 26.2737 12.905 2.01461 18.3128 -4873 4 23.6265 20.0378 26.9508 -1.05622 -6.52034 -10.1156 -4874 4 22.4706 20.8929 26.5742 -3.00423 3.39878 -4.61403 -4875 6 49.3993 29.9017 13.433 -6.38025 27.1117 -0.919919 -4876 4 49.1201 30.8275 13.1802 1.84527 -26.9682 8.98406 -4877 4 48.7504 29.5045 14.041 1.51099 8.43883 -0.914593 -4878 6 2.44855 24.8301 7.30401 -10.5471 2.4163 20.698 -4879 4 2.41495 24.6588 8.2845 -1.1432 9.4633 -23.8545 -4880 4 1.72338 25.455 7.1058 6.30785 -9.44609 7.39061 -4881 6 30.3915 26.4508 14.3344 -6.38639 41.9339 41.7386 -4882 4 31.0669 26.3804 15.0403 -0.162406 -14.5956 -15.076 -4883 4 29.932 27.2875 14.6522 8.5071 -34.3491 -22.1885 -4884 6 27.0361 32.5047 3.13805 -13.013 14.5566 5.91638 -4885 4 26.4776 33.1542 3.63465 13.8957 -14.3888 -12.6314 -4886 4 27.3381 31.8882 3.81715 0.997102 -1.94867 -0.811892 -4887 6 34.2693 14.8073 1.28197 14.9869 -24.9335 -24.2287 -4888 4 35.1732 14.4308 1.1613 -12.3133 12.1546 9.27146 -4889 4 33.7818 14.2606 0.617478 5.51233 18.0169 18.4334 -4890 6 30.0243 8.54272 1.33127 -15.3984 1.11418 15.9731 -4891 4 29.9557 9.47917 1.12547 1.89625 5.05184 -1.94546 -4892 4 29.278 8.4251 1.95594 13.4411 -5.55834 -8.66406 -4893 6 42.5535 11.5155 27.7085 15.437 -3.44919 -13.726 -4894 4 42.3225 12.4337 27.8881 -6.79772 -1.02898 5.45325 -4895 4 41.899 10.9203 28.077 -14.0379 1.06089 7.70623 -4896 6 52.4658 39.5603 17.8381 6.64956 -28.6351 -32.0971 -4897 4 51.7413 39.7621 18.3991 -22.9429 13.2738 25.1291 -4898 4 53.1708 40.1592 17.9962 19.9289 22.995 10.0024 -4899 6 33.211 4.92827 31.629 -12.2211 32.167 9.39859 -4900 4 32.8163 5.83971 31.6275 7.84415 -21.2817 2.59476 -4901 4 32.9135 4.52627 30.8083 -0.68235 -2.18314 -5.10952 -4902 6 6.29493 15.9859 18.7482 13.6791 10.985 9.78561 -4903 4 5.93033 16.6016 19.4273 2.88753 -17.718 -13.1605 -4904 4 5.60754 15.3724 18.4768 -10.6912 0.909102 4.08099 -4905 6 8.51749 14.5386 24.6879 -5.02573 1.07483 -2.93277 -4906 4 9.38168 14.4087 25.0828 4.4136 1.3116 3.34168 -4907 4 8.20169 13.6557 24.4566 1.37146 0.850768 1.15416 -4908 6 22.6856 10.1159 32.1347 3.63858 -5.5341 -7.29103 -4909 4 22.4401 11.0127 32.2731 -27.0162 20.0988 15.0061 -4910 4 23.4682 10.3148 31.6383 25.2173 -15.197 -13.8617 -4911 6 11.2884 2.11431 14.6724 -33.0968 -7.95794 -19.898 -4912 4 10.3134 2.08073 14.4479 21.8664 -1.34414 10.3974 -4913 4 11.7152 2.30811 13.8211 9.70644 2.30495 0.939267 -4914 6 44.9099 15.5878 36.2745 25.7257 2.41581 -13.4012 -4915 4 45.0546 15.5553 35.3019 -10.2235 2.9059 20.3658 -4916 4 43.9848 15.4747 36.4307 -17.7944 -2.84066 -0.111047 -4917 6 9.72168 19.0116 31.2214 10.0341 -21.2505 -12.9994 -4918 4 10.5925 19.389 31.3727 0.996524 0.534629 3.32861 -4919 4 9.08651 19.5363 31.6795 -15.0033 12.5653 12.9482 -4920 6 51.9861 7.59179 16.6767 -2.21949 13.5197 0.492591 -4921 4 52.6037 6.8327 16.6765 -16.3843 6.63384 -16.8766 -4922 4 51.5083 7.75362 15.8118 21.6515 -16.4571 17.7861 -4923 6 31.4364 34.7816 36.4086 3.08769 21.0155 -3.2672 -4924 4 31.7704 34.8477 37.2975 8.82098 -13.2304 13.8104 -4925 4 31.3443 35.7177 36.1951 -3.32863 3.82124 -15.3061 -4926 6 4.22848 15.0876 15.3675 -15.1793 -4.71932 15.5862 -4927 4 4.10446 14.9036 16.3273 5.02277 2.80423 -15.2934 -4928 4 5.16622 15.2495 15.2447 10.6913 1.67801 0.337818 -4929 6 47.7535 20.6847 28.0297 3.73811 3.24498 -1.95167 -4930 4 47.6703 19.7739 27.6852 3.21079 12.9013 3.0329 -4931 4 48.3469 21.1738 27.4217 -9.1514 -8.95746 6.26441 -4932 6 15.7983 1.14885 24.4111 -6.64534 16.957 -16.446 -4933 4 15.3695 0.397874 24.8496 -11.2605 5.13601 -9.62176 -4934 4 15.1572 1.72115 23.8957 14.1067 -25.56 23.4483 -4935 6 34.5718 39.7067 40.0668 -5.06722 14.7699 1.92827 -4936 4 34.1159 40.1215 40.7935 -0.0189783 27.8984 7.01187 -4937 4 34.2456 38.8495 40.221 -5.22714 -44.7262 -10.8544 -4938 6 20.1936 32.176 34.4055 -22.5016 27.7868 41.3602 -4939 4 19.6673 32.7687 35.0502 14.2298 -29.0143 -30.198 -4940 4 21.0584 32.1328 34.8407 -2.28869 -2.39527 -4.5293 -4941 6 19.3074 38.5208 11.8317 17.689 14.4135 -2.63233 -4942 4 19.236 37.5914 12.0232 -0.177798 -10.0936 4.99209 -4943 4 20.0172 38.8749 12.4245 -13.7536 -7.85063 -8.99287 -4944 6 6.52955 13.5023 26.836 -16.6143 37.6784 -17.6139 -4945 4 6.084 14.0762 26.1427 18.8957 -21.2062 24.9102 -4946 4 6.49663 12.6281 26.4634 0.197125 -15.4908 -4.14034 -4947 6 23.5952 31.5638 33.3318 1.16311 -12.5666 -5.83621 -4948 4 23.0836 31.562 34.1475 0.610672 3.97154 0.891929 -4949 4 23.5328 30.6432 33.0053 1.46337 8.27478 -1.79938 -4950 6 41.0778 31.9114 16.1974 16.3032 -14.6541 -18.8682 -4951 4 41.8878 32.072 16.7344 -12.1593 -9.44827 -16.6375 -4952 4 41.2894 31.3264 15.4036 6.53327 16.9697 25.199 -4953 6 31.7476 18.8699 19.3483 9.2825 22.1595 5.37598 -4954 4 32.0642 19.7361 19.7036 -9.20895 -19.367 -8.68372 -4955 4 31.4026 18.3831 20.1168 1.10858 -0.37958 -4.48043 -4956 6 10.4875 4.12209 19.3444 6.70816 11.4672 -10.0773 -4957 4 9.70261 4.48263 18.8666 20.7562 -4.21822 -0.723312 -4958 4 11.3166 4.33216 18.8218 -27.5212 -3.06207 15.0001 -4959 6 1.37991 32.4635 19.2846 24.7257 -29.6508 -15.3303 -4960 4 1.97113 31.6954 19.1311 -3.90248 7.07021 19.3035 -4961 4 1.16609 32.6455 18.3731 -9.24935 13.5936 -9.63824 -4962 6 42.8716 16.8513 24.9892 37.8526 -21.8211 -51.5646 -4963 4 42.4398 17.6894 25.0051 -12.6784 17.6471 3.13223 -4964 4 43.4179 16.871 24.1222 -26.4831 0.994324 39.976 -4965 6 45.3183 19.1979 4.10041 6.37956 15.045 3.35342 -4966 4 46.1127 19.7887 4.04575 -15.2131 -7.48775 2.85843 -4967 4 44.6191 19.6898 4.58798 10.0124 -1.75765 -5.61527 -4968 6 29.1291 19.8804 35.7574 13.154 -41.1853 -12.3735 -4969 4 28.6049 20.2559 36.4387 -19.4183 16.2678 16.1743 -4970 4 29.3151 20.5439 35.0927 -1.78114 11.3903 -2.63997 -4971 6 31.9353 21.8377 19.6787 8.2762 14.7684 -3.54893 -4972 4 32.7301 21.8918 19.0885 -22.5823 -4.29925 15.9785 -4973 4 31.6692 22.7774 19.8195 3.83825 -20.8185 -1.08359 -4974 6 39.1936 8.26228 18.8336 -23.7578 16.4079 -2.4793 -4975 4 38.9784 7.343 18.63 -1.41923 -3.63173 -0.882922 -4976 4 38.3593 8.77699 18.6285 24.7505 -17.6369 4.60834 -4977 6 33.27 13.2649 41.2621 -10.1289 -28.0457 11.6457 -4978 4 32.3532 13.5818 41.1472 2.43324 -1.71459 -0.314725 -4979 4 33.2053 12.355 41.6729 1.3348 20.3333 -9.56947 -4980 6 5.93721 29.5458 35.7995 -7.4397 -15.3695 -5.23966 -4981 4 6.3797 30.3135 36.1022 6.42857 23.5026 12.0451 -4982 4 6.51225 29.246 35.0987 1.02237 -6.8727 -9.18458 -4983 6 13.023 34.1764 31.9266 -10.1581 -4.84889 27.419 -4984 4 13.003 33.3874 31.3637 -4.82745 -5.23795 6.11925 -4985 4 12.6053 33.9771 32.8123 10.4055 -1.49763 -26.3146 -4986 6 33.9757 21.8032 17.9969 16.1152 -19.1834 -4.43927 -4987 4 34.6651 21.0941 18.0436 -13.0194 10.1005 -1.31384 -4988 4 34.4424 22.6001 17.7557 11.611 10.6919 -5.33679 -4989 6 35.9777 41.3398 18.1614 -6.56463 -6.11943 -26.9477 -4990 4 35.8856 41.423 17.1648 6.35377 -3.40276 32.4743 -4991 4 36.5823 0.128109 18.4064 3.22136 6.47441 1.04719 -4992 6 34.856 37.6452 30.5972 -0.647303 3.94572 7.36538 -4993 4 35.2577 36.9607 30.0196 0.445186 1.06156 15.4535 -4994 4 34.8848 37.3986 31.5588 5.49281 -5.52744 -23.9922 -4995 6 25.9972 34.4216 4.68589 -10.7784 -9.94602 -21.2075 -4996 4 25.3582 34.53 5.39473 2.66172 5.48603 12.8385 -4997 4 26.8259 34.8497 4.89674 4.47855 8.12742 13.9663 -4998 6 19.0606 33.5662 1.31783 4.31184 23.0948 -29.5486 -4999 4 19.7493 33.0549 1.74461 7.17592 -5.61608 3.87291 -5000 4 19.5019 34.1007 0.592753 -8.94353 -18.7796 23.9626 -5001 6 25.2721 8.22916 8.60038 8.3672 -6.50911 13.4278 -5002 4 25.4774 8.1828 9.55838 -2.37789 7.03817 -10.0574 -5003 4 25.4001 9.14285 8.30246 -0.229164 -0.61302 1.82749 -5004 6 12.8408 19.6874 13.0432 23.1779 -10.767 -3.57874 -5005 4 11.9236 19.9359 13.0109 -16.1394 8.08564 -1.3752 -5006 4 13.3549 20.4875 12.8299 -11.6819 -5.55115 1.76181 -5007 6 53.3458 11.4322 5.81729 13.7919 -26.0181 10.511 -5008 4 53.941 11.999 6.3288 -5.2171 7.54934 -1.97002 -5009 4 52.6156 11.905 5.44666 -11.025 16.6744 -4.72885 -5010 6 9.84401 16.0447 31.1965 1.52473 25.7097 1.4485 -5011 4 9.0725 15.75 30.7245 -12.2986 -10.5074 -10.4763 -5012 4 9.76401 17.0228 31.1974 4.09395 -10.8484 3.46066 -5013 6 25.4337 20.2897 3.31222 -0.0744965 -16.6885 15.2888 -5014 4 25.4502 20.7681 4.1742 1.29774 3.58896 -22.0188 -5015 4 25.617 20.9088 2.59036 0.892976 4.59184 10.0233 -5016 6 20.7687 8.19442 15.6442 -13.8219 -45.5838 -0.24202 -5017 4 20.3131 8.5145 16.4113 -6.16339 18.6345 13.1662 -5018 4 20.3525 7.29833 15.5772 17.5129 18.5489 -8.91575 -5019 6 37.6537 8.61162 9.99803 6.38032 -10.5281 17.8344 -5020 4 37.9174 7.70722 10.2264 -2.01487 8.44182 4.78342 -5021 4 37.3414 8.51532 9.10193 -3.86116 3.7435 -6.65528 -5022 6 50.6588 4.51187 24.2729 -10.1552 -3.70856 6.87258 -5023 4 49.9071 3.88527 24.1971 13.583 4.61791 0.248303 -5024 4 51.4381 4.036 24.5943 -3.42543 -3.47462 2.6777 -5025 6 20.1632 24.8244 34.8962 -12.0105 28.899 -22.2545 -5026 4 19.9486 25.4522 34.1467 5.29317 -18.0262 19.0072 -5027 4 20.331 23.9626 34.5117 -0.31696 -10.3492 -2.27521 -5028 6 30.5785 22.522 11.2467 -2.76969 13.8933 23.9619 -5029 4 31.2526 22.1243 10.7257 13.2932 -13.8734 -17.1472 -5030 4 31.019 23.338 11.5119 -11.6942 5.7798 2.38886 -5031 6 17.322 40.803 8.03266 14.2969 -15.2802 9.14469 -5032 4 17.3696 39.9923 8.55945 -20.3131 5.85274 7.92005 -5033 4 18.1352 40.6655 7.5489 4.4024 9.10004 -19.1526 -5034 6 23.9661 41.0457 26.0803 21.1205 -0.428792 10.5169 -5035 4 24.3123 40.6207 25.2948 17.4674 -5.32369 -4.96192 -5036 4 23.0464 41.0448 25.8953 -36.0489 4.67224 4.09659 -5037 6 9.79449 25.5813 27.216 11.7002 -20.4303 -20.1428 -5038 4 10.1564 25.0129 26.491 -8.57195 17.3601 17.171 -5039 4 10.1924 25.2359 28.0288 -3.53182 0.239058 0.558234 -5040 6 35.2535 29.8267 24.7533 16.8399 6.514 6.92542 -5041 4 34.3962 29.6585 24.3475 -6.29365 6.70405 -5.90439 -5042 4 35.51 30.7547 24.57 -10.2352 -8.20594 -2.77553 -5043 6 2.14051 4.25227 10.5512 -4.35014 2.09559 7.87868 -5044 4 1.87018 4.24401 11.51 4.03105 2.56783 -22.6964 -5045 4 1.48695 4.75313 10.0317 0.0426026 -1.98947 12.7879 -5046 6 43.1755 3.92129 23.5016 -16.6861 -14.9885 0.818311 -5047 4 43.8939 4.14262 22.9078 7.68421 2.83398 -7.81803 -5048 4 42.5577 3.34913 22.9937 11.3891 7.34243 2.48813 -5049 6 18.8996 22.6297 2.43765 22.7339 -13.1014 -2.24121 -5050 4 19.79 22.181 2.40524 -25.7911 11.1615 4.63986 -5051 4 18.7139 22.8085 3.37028 4.18935 -2.21949 -1.21374 -5052 6 20.4908 18.9405 41.5599 0.284845 -17.4141 21.8797 -5053 4 20.1374 18.6064 0.533469 2.69626 22.1818 -33.2143 -5054 4 19.9839 19.6587 41.147 -4.56676 -6.01516 12.1125 -5055 6 26.4163 7.55623 29.1338 1.47231 -3.25042 -11.8229 -5056 4 25.7099 7.08251 28.6481 8.40182 7.03804 13.9135 -5057 4 27.0821 7.71224 28.4448 -4.02075 -2.1597 11.7889 -5058 6 25.6465 35.5679 33.7595 -11.9902 -19.4032 2.16293 -5059 4 26.3374 36.2384 33.6103 2.60319 -14.9989 -6.30077 -5060 4 25.8315 34.6987 33.2841 2.54327 33.8846 12.2934 -5061 6 24.8333 0.493635 8.41989 34.5336 11.5552 47.2955 -5062 4 25.5249 0.302877 9.1499 -35.8013 6.01564 -39.2036 -5063 4 24.7614 41.6068 7.91956 0.436288 -16.6888 -13.1367 -5064 6 17.008 17.3182 3.45493 -26.2706 15.7324 15.4846 -5065 4 16.2426 17.9829 3.53843 29.8189 -30.5055 4.13684 -5066 4 17.1653 16.9244 4.35506 -11.2277 16.1793 -19.3505 -5067 6 40.1827 32.1035 19.3506 13.0539 -5.95213 0.358733 -5068 4 39.8335 31.2604 19.604 -25.4023 -11.2285 12.0125 -5069 4 40.9513 31.7409 18.9215 18.5667 14.352 -9.19942 -5070 6 23.3808 26.7171 6.31746 29.0762 21.4976 14.3842 -5071 4 24.13 27.3908 6.46801 -30.1018 -19.5893 -7.69607 -5072 4 22.7349 27.0723 5.68536 3.11778 6.18165 -0.6273 -5073 6 28.6527 28.5112 1.41186 -10.6623 -30.4119 4.69741 -5074 4 28.683 29.4458 1.20631 15.125 4.74584 -7.70298 -5075 4 29.5288 28.0803 1.2704 -12.115 26.7011 1.44139 -5076 6 12.0438 6.3157 14.0384 -8.70244 -3.06108 -4.52058 -5077 4 11.2798 6.1721 13.4181 27.4537 -0.215786 8.28745 -5078 4 12.8925 6.19521 13.5554 -16.057 2.9292 1.41242 -5079 6 20.1243 33.7022 32.0954 -30.4257 7.53408 -8.19993 -5080 4 20.1371 33.1054 32.8412 7.6416 -5.80656 10.7415 -5081 4 21.0197 33.8732 31.8382 18.9224 -1.8204 -0.321518 -5082 6 12.0625 33.3632 34.5388 -0.325915 -41.4281 -23.9157 -5083 4 11.5602 33.8727 35.1697 -10.674 0.646784 10.687 -5084 4 11.6234 32.4653 34.3673 14.5179 34.5198 8.14895 -5085 6 6.00279 22.2605 25.0501 2.06163 -11.5991 79.3474 -5086 4 5.88194 22.3996 24.153 -16.4068 14.8809 -57.8418 -5087 4 5.25089 22.6367 25.5854 16.5977 -6.05374 -22.2773 -5088 6 28.8802 9.48792 11.0269 30.0757 -27.8021 5.60101 -5089 4 29.142 10.167 11.6644 -15.2392 1.2069 -12.766 -5090 4 28.0854 9.70897 10.5587 -15.7703 15.13 -3.00542 -5091 6 25.9783 31.1564 24.8742 0.212243 -23.2246 11.0271 -5092 4 26.2703 31.9474 24.4305 5.78101 9.73635 -10.8861 -5093 4 26.5948 30.4205 24.6499 -9.08002 14.2421 1.82694 -5094 6 17.4069 22.6321 26.9528 -11.8732 29.0046 13.506 -5095 4 17.1509 23.4374 27.5137 11.798 -28.7792 -23.9739 -5096 4 17.5283 21.9112 27.5803 0.671776 -8.09241 2.21186 -5097 6 30.9731 17.6144 1.64569 13.582 26.8251 31.1357 -5098 4 30.2123 17.6859 1.07719 -13.0538 -2.75682 -13.3747 -5099 4 31.0067 18.4528 2.19078 1.05257 -25.2161 -14.5596 -5100 6 35.2833 9.73343 11.2271 -16.277 -4.62114 -26.0747 -5101 4 34.627 9.45499 10.5137 29.3374 5.62349 25.4867 -5102 4 36.1567 9.37366 10.9701 -6.28276 0.375521 -3.01301 -5103 6 12.0057 10.8077 4.27601 -12.2512 -1.40581 -7.43609 -5104 4 11.4458 10.5898 5.05281 2.39288 0.24657 -15.6405 -5105 4 11.51 10.5288 3.46435 7.55978 2.35404 20.8087 -5106 6 52.9546 23.1284 7.66438 3.19212 11.9041 -9.13647 -5107 4 53.8155 23.0936 7.22037 1.72331 -6.21969 -0.472682 -5108 4 52.7997 24.0739 7.82392 -0.633169 -8.94194 3.43433 -5109 6 27.374 5.80114 23.1096 7.51778 12.7335 11.6917 -5110 4 28.1753 5.52132 23.6349 -22.415 18.9583 -13.4562 -5111 4 27.3645 6.79042 22.9959 5.3793 -33.2455 5.89418 -5112 6 22.7689 37.6996 15.5372 -5.91943 -7.67105 33.7333 -5113 4 22.8436 37.842 14.6084 2.14719 5.97904 -25.5056 -5114 4 23.2999 36.9284 15.7907 -0.822855 1.46565 -2.93441 -5115 6 30.5901 30.1355 39.7465 -8.92084 9.99629 -19.6672 -5116 4 30.0839 29.6315 39.0953 -1.54922 -9.94816 6.16305 -5117 4 30.5761 31.0154 39.3281 8.00114 -4.73058 9.29019 -5118 6 26.5152 14.8694 29.9646 3.93344 -0.205179 -3.29595 -5119 4 25.7559 15.3094 30.3103 -24.5604 12.1261 -1.41502 -5120 4 27.0839 14.9289 30.718 22.1413 -5.57177 12.178 -5121 6 9.52543 19.5487 37.4182 -4.93509 -3.75546 7.04348 -5122 4 8.56858 19.5373 37.6772 20.7537 10.8584 -9.00922 -5123 4 9.7741 20.4052 37.0166 -14.5013 -9.56436 9.93265 -5124 6 0.91928 14.8658 2.69601 -17.5095 9.99019 63.3715 -5125 4 1.47581 15.1737 2.02419 28.2707 8.36374 -43.6031 -5126 4 1.18821 15.4309 3.47389 -7.04008 -21.0896 -18.5042 -5127 6 46.427 27.1287 41.5945 43.2461 -1.33556 -25.8044 -5128 4 47.402 27.2052 41.2817 -46.4011 -2.64418 15.4668 -5129 4 46.0299 26.5803 40.8989 0.996959 5.24299 8.87294 -5130 6 47.678 23.0562 21.3872 5.44089 38.3346 6.01366 -5131 4 46.9403 23.2179 20.8133 -13.997 9.90145 -6.64011 -5132 4 47.7418 22.1285 21.385 8.56341 -43.7487 4.99103 -5133 6 39.8587 22.235 3.08723 2.37939 -15.5871 -9.21378 -5134 4 39.0088 22.2526 3.53641 -4.44104 7.43329 4.08383 -5135 4 39.9535 21.2857 2.86173 -0.917299 22.2801 6.61021 -5136 6 14.9853 14.9328 33.4647 9.90785 18.6887 5.96998 -5137 4 15.4024 15.8269 33.5858 -13.0369 -24.3412 -0.758701 -5138 4 14.5599 14.6915 34.3048 3.28451 6.61064 -6.43534 -5139 6 27.3302 11.4834 31.9317 -27.4366 -15.9755 21.8219 -5140 4 26.9982 12.0952 32.5883 -9.79098 -5.70708 8.51591 -5141 4 28.0752 11.9422 31.6406 46.9031 18.536 -28.2392 -5142 6 36.7579 7.97089 7.62034 -1.24967 -18.9477 -14.6485 -5143 4 35.954 7.42009 7.70022 6.4697 6.94413 -3.0671 -5144 4 37.4142 7.36122 7.22008 -3.07725 6.9494 1.66736 -5145 6 49.4451 9.66335 18.2174 -4.20907 -17.0946 -5.32386 -5146 4 50.1075 10.0642 17.6138 -11.2883 10.4151 20.0604 -5147 4 49.0937 10.2089 18.9473 16.8995 10.9543 -13.1485 -5148 6 27.0353 33.866 10.7555 -3.61813 20.4819 39.0174 -5149 4 27.1089 33.3944 9.9425 -11.0368 -7.55411 -28.9907 -5150 4 26.1735 34.332 10.8422 4.28798 -12.7598 -13.2634 -5151 6 11.1949 37.4624 6.84871 0.36549 -16.8746 15.3404 -5152 4 10.8648 38.3395 6.66289 0.465253 11.7734 -2.90488 -5153 4 12.1583 37.5341 6.85599 1.64848 0.115814 -1.2743 -5154 6 19.2537 19.4156 21.9114 -15.7985 8.22585 33.6704 -5155 4 18.5515 19.3251 21.2863 -16.3583 -5.26309 -15.3133 -5156 4 20.0646 19.323 21.4355 25.7859 -3.53787 -14.4318 -5157 6 54.4972 2.91444 22.5674 41.6328 11.7794 25.4635 -5158 4 54.323 3.09449 21.6644 -16.7292 4.15243 -34.296 -5159 4 0.405558 3.31869 22.7045 -24.6299 -12.807 4.19326 -5160 6 45.0583 10.8549 24.2301 5.83399 20.0221 21.0618 -5161 4 44.4296 11.5751 24.1426 -7.03973 -3.51443 -9.4179 -5162 4 45.6095 11.2138 24.9523 4.1225 -19.1196 -10.3672 -5163 6 14.387 34.402 24.7643 -0.614961 -5.50567 -8.46915 -5164 4 14.802 35.2302 25.0278 -0.621724 2.17228 4.67692 -5165 4 14.8142 34.1913 23.9221 -0.527667 -3.77388 -2.27373 -5166 6 50.586 17.557 4.30707 17.1275 -18.9627 18.6811 -5167 4 51.3126 17.9927 4.759 8.45418 -3.82203 7.11351 -5168 4 50.1863 18.2804 3.88376 -26.598 27.5468 -24.7799 -5169 6 14.9317 33.3337 34.1113 -12.3404 20.8418 56.9019 -5170 4 15.0455 32.9404 33.2912 5.44957 -23.8922 -53.334 -5171 4 14.0148 33.1563 34.3942 8.12215 6.97131 -5.23034 -5172 6 20.8706 33.5768 38.9143 15.1188 7.04694 -15.6549 -5173 4 20.7999 34.008 39.7578 -2.44584 7.66125 17.1111 -5174 4 20.3826 32.7659 38.9944 -10.1095 -18.4284 -0.973943 -5175 6 7.78494 4.73961 26.7587 18.7098 -5.63937 13.378 -5176 4 7.2181 5.0845 27.4506 -5.7435 6.37459 2.19378 -5177 4 7.246 4.75931 25.9687 -5.82922 -1.99593 -5.70414 -5178 6 9.28281 21.4851 22.3014 51.087 14.0475 -25.6174 -5179 4 8.74732 21.9732 21.6886 -31.0609 5.1079 -5.58489 -5180 4 10.1706 21.7227 21.8793 -22.1752 -18.3044 28.8298 -5181 6 20.5441 38.2146 8.8638 -2.83914 11.917 26.817 -5182 4 20.3663 38.6401 9.7626 4.81036 -21.6973 -30.7816 -5183 4 20.4013 37.2533 8.94236 -1.07384 9.24152 7.62946 -5184 6 30.1053 39.0795 30.7451 -13.6764 41.2724 28.6819 -5185 4 30.3998 39.946 31.2193 -9.10868 -42.8123 -24.766 -5186 4 29.1169 39.0706 30.8728 28.3121 -0.882933 -5.94109 -5187 6 16.0486 22.0268 24.5039 34.2787 3.60452 0.906339 -5188 4 16.7735 22.0671 23.8432 -14.3833 -3.87047 -0.289875 -5189 4 16.5419 22.3002 25.3044 -14.2176 -3.36187 3.5873 -5190 6 5.74232 29.2062 14.4594 -18.34 10.8061 -32.1404 -5191 4 6.48422 28.7094 14.7814 11.5218 -3.49899 17.506 -5192 4 5.24211 29.6259 15.1721 5.10135 -5.91064 9.04276 -5193 6 28.0673 3.08827 25.2267 -6.08854 1.42804 12.0746 -5194 4 28.6661 3.71086 24.7756 -7.19123 -0.840207 10.3279 -5195 4 27.7106 3.5203 26.0449 13.0908 -0.523763 -20.3567 -5196 6 45.9319 29.2971 31.4223 -7.33073 21.7818 28.5056 -5197 4 45.7264 28.738 30.6765 -12.0419 -4.51403 -16.7723 -5198 4 45.1872 29.9464 31.611 20.2512 -24.9239 -13.0948 -5199 6 11.2178 22.8398 36.7928 3.83605 7.6889 -19.1741 -5200 4 10.7288 23.4227 36.1801 1.54849 -6.36416 6.79315 -5201 4 12.0227 22.5824 36.3 -5.92076 -0.954096 11.0422 -5202 6 18.9236 40.1387 39.9284 -8.72712 -15.4473 12.674 -5203 4 19.137 39.1923 39.9727 -1.01676 1.76774 -7.47997 -5204 4 18.926 40.4024 40.8597 -1.95632 5.76083 -1.10583 -5205 6 23.5567 26.0801 21.2876 -20.8354 -5.58511 20.4095 -5206 4 22.8283 26.6117 20.9473 7.44123 1.31497 -7.03875 -5207 4 23.1869 25.6705 22.0991 12.7429 3.57595 -14.6326 -5208 6 16.8309 5.38685 15.8596 17.5735 -24.6285 20.3591 -5209 4 16.4468 5.29371 14.9868 -10.6119 14.9975 -0.930521 -5210 4 16.6163 6.1995 16.3389 -7.69088 7.65746 -13.895 -5211 6 12.049 26.6129 14.9962 1.83385 5.07399 -16.0821 -5212 4 11.6864 25.936 15.5307 6.55853 -24.3886 27.1256 -5213 4 11.2609 26.839 14.5085 -0.894459 16.8406 -16.785 -5214 6 14.3334 41.4222 2.37421 26.0216 21.5484 -18.2857 -5215 4 13.7051 40.9662 2.90199 -22.7144 -12.1023 21.977 -5216 4 14.3738 0.426145 2.71152 -4.41702 -11.6567 2.07407 -5217 6 50.4009 35.8582 9.31454 24.1561 17.2373 -12.1424 -5218 4 50.8168 35.8748 8.42953 -10.1576 -5.67977 3.83986 -5219 4 50.8977 36.5714 9.7704 -11.7974 -14.2445 3.10197 -5220 6 11.3695 22.6672 26.8678 6.20997 3.92483 11.2558 -5221 4 12.2048 22.3333 26.5164 -4.88328 -1.76893 -0.685046 -5222 4 10.6892 22.391 26.2565 -8.40373 -4.36232 -8.95219 -5223 6 8.45148 34.5593 21.2814 -25.9919 -59.0281 13.1791 -5224 4 8.04792 35.0446 21.9998 -0.548909 12.0582 7.93151 -5225 4 8.02348 33.6171 21.3881 27.3669 48.26 -12.6189 -5226 6 9.41918 8.68911 24.4735 -32.1109 22.232 -11.1027 -5227 4 8.45415 8.80658 24.2608 22.5553 -3.45738 3.03744 -5228 4 9.54271 9.26889 25.2379 6.1219 4.18012 4.13063 -5229 6 32.6166 22.3351 34.507 3.90791 9.0503 -27.7323 -5230 4 32.5036 23.1955 34.0662 0.599489 -5.17288 -1.28756 -5231 4 32.8196 22.6091 35.3861 6.87298 3.84758 30.2519 -5232 6 26.7427 26.1702 7.11338 18.0622 8.0778 -11.4877 -5233 4 26.0574 25.7087 7.60312 -9.51312 -3.43645 7.19196 -5234 4 26.4504 27.0916 6.97179 -2.60416 -16.0173 4.37043 -5235 6 33.9976 11.9299 3.97475 -1.16308 1.75568 6.69865 -5236 4 33.7915 11.6388 4.87314 3.4696 4.99202 0.68255 -5237 4 33.8545 12.8906 3.99294 -0.306808 -3.71184 -1.40707 -5238 6 21.4819 20.9256 37.2108 -8.76322 20.972 13.918 -5239 4 22.36 21.3309 37.2026 5.25525 -6.97128 0.105034 -5240 4 21.5739 19.9858 37.0637 7.9716 -15.2147 -3.23728 -5241 6 18.467 41.0278 0.654954 -19.554 -29.5721 -12.8619 -5242 4 17.5024 41.1258 0.530294 8.77033 6.01734 2.0842 -5243 4 18.8042 41.8885 0.845086 4.40915 26.8371 2.49279 -5244 6 41.3548 41.7118 25.1844 12.9409 14.5374 -0.392323 -5245 4 40.9222 40.8883 25.4041 -6.90081 -12.2223 3.22908 -5246 4 41.5202 41.6634 24.2378 -1.56977 -0.361026 -1.444 -5247 6 27.6369 28.1312 3.93858 39.9773 31.9241 -60.8173 -5248 4 27.7577 28.1455 2.91253 -1.05119 3.80663 52.0412 -5249 4 26.945 27.5412 4.09124 -36.8498 -31.9254 8.70709 -5250 6 18.2839 10.5111 31.4966 0.533258 -0.0130678 0.979798 -5251 4 17.4029 10.1636 31.5665 -10.6602 -13.9647 -0.00296819 -5252 4 18.1106 11.4466 31.5267 10.9856 11.4938 1.12981 -5253 6 11.3036 37.9694 14.764 4.77413 -10.0896 11.5971 -5254 4 10.7874 37.239 14.4221 -9.53089 5.23111 -9.63971 -5255 4 11.7579 37.5414 15.5118 -2.30342 16.6377 -5.07599 -5256 6 0.816524 18.1414 27.5647 20.1272 -0.3628 -0.469578 -5257 4 0.17179 17.4415 27.469 -11.396 -5.37013 -1.78049 -5258 4 1.63281 17.6507 27.785 -7.45447 11.2502 -1.88757 -5259 6 36.8008 10.7378 20.295 8.4208 9.86458 8.47872 -5260 4 36.1948 10.0642 20.0001 -9.44027 -8.16387 -5.04241 -5261 4 36.5983 10.8279 21.2363 1.65531 0.40354 2.85938 -5262 6 47.4201 25.5213 8.04394 8.74054 5.57223 -13.14 -5263 4 47.3566 25.6372 7.0634 -2.71671 -4.96685 23.4826 -5264 4 46.5708 25.2582 8.40304 -6.39129 0.734124 -5.55138 -5265 6 13.9238 35.1275 16.0037 32.5083 18.1998 3.59786 -5266 4 13.2022 34.5755 16.1957 -32.489 -30.3694 18.6715 -5267 4 13.7597 35.4303 15.121 4.25156 9.41728 -20.5426 -5268 6 29.562 35.3734 16.1776 -35.0835 -2.07929 -8.00281 -5269 4 30.2224 34.9599 16.7245 13.9673 -5.91711 9.2078 -5270 4 28.7051 34.8863 16.2926 25.5199 12.926 -4.35301 -5271 6 29.4722 25.8866 32.4187 14.354 2.72026 -23.1845 -5272 4 28.9025 25.7608 33.1796 -14.4011 -9.23541 2.43376 -5273 4 29.1922 25.3818 31.6086 -3.9853 6.0929 23.1903 -5274 6 24.1343 2.13601 25.4438 45.8363 12.8335 -27.0328 -5275 4 24.6226 2.81425 24.8647 -23.4035 -21.9591 22.2831 -5276 4 24.7019 1.32842 25.3981 -18.0817 13.4017 1.18969 -5277 6 4.54354 34.4275 19.14 11.1292 -12.0398 21.377 -5278 4 4.4735 34.5954 18.1883 -15.738 1.03246 1.7136 -5279 4 3.71635 34.4131 19.6775 9.89222 2.06937 -18.6971 -5280 6 10.1248 17.2257 14.3121 -1.66581 -5.60367 -9.60454 -5281 4 10.2583 17.5937 15.1679 8.8306 2.43924 21.0325 -5282 4 9.4989 17.8227 13.9164 -6.75609 1.38519 -13.487 -5283 6 21.4392 41.7587 34.6855 22.2624 7.769 -11.2018 -5284 4 21.5032 41.1211 35.405 -13.4071 -7.19641 7.36579 -5285 4 20.544 -0.0182627 34.3462 -4.72666 -12.2957 11.4101 -5286 6 36.1543 24.108 12.5954 -4.82194 -9.49577 -8.67068 -5287 4 35.691 23.694 13.3698 5.25066 1.62288 -23.6525 -5288 4 35.776 23.8018 11.7194 2.97337 4.42231 26.8685 -5289 6 49.5838 18.601 19.9434 7.37368 0.836531 -4.03301 -5290 4 50.0063 19.3607 19.4891 -2.40205 -12.3461 5.19746 -5291 4 50.2865 17.9356 20.0577 -3.44895 8.52353 -2.14521 -5292 6 1.26001 7.05318 14.4907 38.3056 -26.8237 -27.7837 -5293 4 1.8201 6.82299 13.6677 -23.9217 11.4061 34.9177 -5294 4 1.48256 6.35829 15.148 -4.21477 12.5307 -9.57675 -5295 6 12.7431 22.7759 31.2417 -21.5742 -17.6245 -17.2109 -5296 4 12.7068 22.0167 30.6251 -0.189583 12.5272 11.0438 -5297 4 13.6543 23.0267 31.2833 20.8009 4.17698 1.04357 -5298 6 8.18693 18.6259 27.8062 12.2535 -2.56913 -7.18349 -5299 4 8.40416 17.6764 27.919 2.05523 15.8207 -2.89848 -5300 4 8.90605 19.0032 27.258 -7.77238 -10.2714 7.52916 -5301 6 52.132 28.0244 15.3085 -5.0475 -8.46487 8.97907 -5302 4 52.2845 27.4141 14.5747 1.7297 4.34316 -0.517396 -5303 4 52.1194 28.9169 14.9336 2.1814 -6.82244 -4.33507 -5304 6 52.6909 21.916 10.0977 -8.33066 3.09691 2.06611 -5305 4 53.4463 22.3007 10.5387 10.5159 5.84972 4.87058 -5306 4 52.7807 22.2562 9.19728 -3.40401 -0.944397 -1.81328 -5307 6 22.3502 5.78024 2.67711 -1.19821 4.70475 8.9403 -5308 4 22.3462 5.61537 3.63751 1.98719 -8.03511 -7.01348 -5309 4 22.5962 4.95479 2.25163 2.53332 -12.0932 -0.158426 -5310 6 15.4205 16.2192 21.8867 5.02822 24.0999 -40.4778 -5311 4 14.4784 16.2102 22.0595 -10.022 -3.20892 10.2198 -5312 4 15.4767 16.6809 20.9929 2.09736 -16.6333 30.6862 -5313 6 28.7089 41.2927 33.91 5.52796 3.54283 5.25404 -5314 4 28.727 40.4953 34.4564 -2.79359 -2.24742 -0.170863 -5315 4 27.7951 41.4466 33.6263 4.57527 -2.88437 3.84631 -5316 6 9.01739 31.2727 18.2059 -18.1749 -3.84142 11.7815 -5317 4 8.98151 32.2312 18.3694 0.025829 -3.44513 1.18933 -5318 4 8.52849 30.7949 18.9304 13.8496 11.5721 -17.6376 -5319 6 20.5529 20.3981 18.1799 -10.2473 -3.12886 -8.71499 -5320 4 21.0329 20.6151 18.9854 0.125323 4.65459 7.73128 -5321 4 19.8496 21.0773 18.075 13.4895 -10.4913 3.92819 -5322 6 53.9703 14.7072 37.8312 5.01214 -4.5628 8.74013 -5323 4 53.4666 15.4974 37.9319 -5.56379 24.6001 14.4542 -5324 4 53.6093 14.375 37.0321 1.20033 -18.5897 -21.23 -5325 6 28.9035 15.3885 18.8586 45.4636 -15.1916 -0.680493 -5326 4 29.8469 15.0873 18.5932 -41.6456 12.1347 6.71251 -5327 4 28.9115 15.3505 19.8299 -3.5302 1.25595 -2.12016 -5328 6 2.00256 25.8212 18.9096 3.72723 11.471 14.7099 -5329 4 2.26458 26.6216 18.4327 2.14682 1.88771 -0.892997 -5330 4 1.76414 25.179 18.2501 -5.23937 -11.562 -15.1322 -5331 6 53.2507 40.704 24.2965 8.91441 12.4597 1.37217 -5332 4 53.4683 39.7911 24.0958 -2.511 -10.6834 -0.444896 -5333 4 54.079 41.1598 24.0633 -8.96863 1.63956 3.52407 -5334 6 47.5231 32.0042 22.8531 -14.3462 4.46803 -6.08063 -5335 4 47.3408 32.7709 23.4273 6.00779 -4.56073 2.25025 -5336 4 48.2766 31.5253 23.2067 4.67997 4.39959 7.43042 -5337 6 24.6197 26.1463 33.0089 -12.4366 -5.18424 3.68853 -5338 4 24.4183 25.6868 33.835 -4.3875 -0.159577 -1.83724 -5339 4 25.4547 26.5812 33.1385 10.0429 5.3772 -3.83199 -5340 6 21.3442 17.0884 39.4824 -9.75867 4.42788 -12.86 -5341 4 22.0786 16.6105 39.8509 9.0034 -0.419098 8.66004 -5342 4 20.9617 17.649 40.1682 3.71874 -0.284678 5.70811 -5343 6 11.0324 40.4486 17.0358 15.7971 -30.8577 -26.0801 -5344 4 11.6842 41.1185 17.2103 4.65986 12.9737 2.4903 -5345 4 11.491 39.8695 16.3608 -26.1319 15.9634 25.4848 -5346 6 20.3416 21.2702 39.8615 -24.9835 10.9638 22.3655 -5347 4 20.689 20.9793 39.0389 13.9219 -9.37305 -28.7546 -5348 4 21.0638 21.2843 40.4958 4.25493 1.29328 -0.298347 -5349 6 2.11091 29.6941 22.5934 -5.9509 -23.8702 -11.6938 -5350 4 1.45034 28.9715 22.5035 1.67869 13.3355 3.97539 -5351 4 2.94117 29.2559 22.3631 0.0654014 9.01208 -1.60678 -5352 6 36.7558 30.2897 35.4506 24.3729 -18.3256 16.5828 -5353 4 36.1768 30.1398 36.2224 6.47664 5.98183 -7.75951 -5354 4 37.6324 29.8684 35.7011 -26.9845 14.5763 -5.36474 -5355 6 12.9471 4.31284 37.9204 -6.90268 -11.166 6.10722 -5356 4 12.3078 3.59731 38.1765 12.7034 25.1114 3.17689 -5357 4 12.7446 5.19856 38.3152 -2.40344 -19.0082 -2.01981 -5358 6 38.3332 5.26794 18.4655 -19.3496 19.9027 -29.1997 -5359 4 37.4721 5.17942 18.8804 2.72791 -1.29988 8.64573 -5360 4 39.0241 5.01488 19.0552 15.587 -10.1496 24.0772 -5361 6 10.4858 9.23289 21.7404 -25.2332 -4.10139 2.16313 -5362 4 10.1465 9.25623 22.657 12.6022 -3.18555 -3.91704 -5363 4 11.447 9.27854 21.7188 5.40032 0.87934 7.2107 -5364 6 0.505771 41.0407 17.3245 -0.427706 37.3637 0.906459 -5365 4 1.03474 40.3115 17.5973 10.8601 -24.0642 8.3812 -5366 4 1.07952 41.8285 17.484 -10.202 -14.0113 -5.73388 -5367 6 4.10283 5.07754 6.43738 -38.2782 -14.6693 -26.7901 -5368 4 4.80956 4.44559 6.48511 17.8781 -6.62955 4.00539 -5369 4 4.33824 5.81877 6.9517 16.1672 26.1823 21.8329 -5370 6 11.4353 25.4218 0.164599 -6.84764 4.42394 -1.26617 -5371 4 11.3082 26.3017 0.56247 4.23965 -3.25035 1.30302 -5372 4 12.32 25.1006 0.40702 -4.64442 7.63092 -0.276853 -5373 6 7.41885 21.5502 8.10769 10.495 -13.722 -26.2993 -5374 4 7.61759 21.2522 7.17802 -11.0567 9.56016 28.8323 -5375 4 8.26229 21.8826 8.44859 -7.90548 -1.09713 -4.6635 -5376 6 47.5869 16.3678 25.2584 -15.0789 15.5873 -32.807 -5377 4 46.6352 16.1327 25.0388 32.9447 8.00435 6.4503 -5378 4 47.9767 16.8704 24.4584 -11.2605 -20.3751 33.7323 -5379 6 30.9209 19.4939 39.8451 -11.8548 28.7526 -24.1689 -5380 4 31.8555 19.5183 40.0202 17.1254 -10.6903 10.4692 -5381 4 30.8076 20.3562 39.3598 -8.87252 -26.4956 11.5622 -5382 6 20.3775 24.0331 39.393 16.2123 32.2964 -6.62361 -5383 4 19.46 24.2872 39.3788 -17.3162 -0.971439 2.40317 -5384 4 20.4139 23.0995 39.5119 -7.32592 -29.4126 2.4841 -5385 6 45.906 21.2665 41.1719 -24.2736 -11.4825 -0.885762 -5386 4 46.5804 21.1569 41.8486 15.7955 10.6383 -1.5802 -5387 4 46.0859 21.9477 40.5132 15.7742 6.36757 6.57249 -5388 6 32.5682 28.1996 30.46 3.6658 -10.99 6.0107 -5389 4 32.938 27.299 30.6104 -6.7941 21.8776 -2.09353 -5390 4 33.2105 28.8285 30.8344 -2.85996 -8.65293 -4.24176 -5391 6 18.0144 1.30598 27.0418 -16.6632 -1.71712 -0.445992 -5392 4 17.1007 1.69106 27.0468 26.0213 -5.17059 4.63351 -5393 4 18.4653 1.60291 27.8546 -9.34219 2.14994 -8.02835 -5394 6 39.3706 24.9704 21.8707 -3.8719 -7.6304 -3.05608 -5395 4 39.4638 25.9303 22.0078 -2.06007 -5.24545 2.56571 -5396 4 38.5004 24.7369 22.2528 8.08795 9.92494 -4.1564 -5397 6 33.5838 21.3134 22.0984 8.18441 -4.13225 6.82001 -5398 4 32.7138 21.3502 21.682 2.4933 6.37883 -5.99313 -5399 4 34.1113 22.092 21.8324 -12.1677 -4.37971 -1.53996 -5400 6 40.113 14.9986 15.7558 -14.3933 -54.3129 -47.4443 -5401 4 39.335 14.6192 15.2293 31.4969 18.6384 20.9479 -5402 4 39.7901 15.7154 16.2477 -17.7573 36.9578 24.811 -5403 6 32.6916 17.9228 6.36161 -9.89813 9.73379 -21.0853 -5404 4 32.6423 17.3002 7.0662 1.70901 -17.6566 26.5232 -5405 4 32.2464 17.4542 5.63975 -0.790726 3.03073 -5.51736 -5406 6 50.4678 15.9334 31.144 -39.7004 -26.5385 31.9374 -5407 4 51.253 16.1743 30.7093 39.9028 11.8107 -24.2063 -5408 4 50.5343 14.9829 31.3801 -1.18751 16.0768 -7.78774 -5409 6 23.825 29.3336 31.6412 17.8706 -6.79638 -8.14744 -5410 4 23.7507 29.695 30.7549 -4.03414 2.57591 0.878238 -5411 4 24.7016 28.8907 31.6365 -14.4802 6.46497 6.02506 -5412 6 25.0497 41.6479 38.28 3.49637 2.98657 -6.73496 -5413 4 25.6848 41.2957 37.6072 -14.3525 10.6226 12.6055 -5414 4 24.5759 0.544247 37.957 10.7828 -14.7666 -1.7986 -5415 6 14.3338 25.4719 8.00129 -34.0608 -17.9542 9.33499 -5416 4 15.0375 25.807 7.49197 32.7442 17.1809 -19.3974 -5417 4 13.7504 25.049 7.33286 9.67269 6.09785 11.4563 -5418 6 17.2157 20.7463 5.33337 -33.6161 12.1619 46.6806 -5419 4 17.4746 20.2104 4.61987 19.6997 -12.8632 -39.6831 -5420 4 17.6039 21.6267 5.33982 9.69266 2.06371 -12.0346 -5421 6 18.8632 10.9532 23.7128 -6.45661 -28.7698 -18.1749 -5422 4 18.5024 10.4645 22.9505 4.54871 -4.25462 9.96764 -5423 4 18.7195 11.8343 23.4273 2.43458 32.1183 3.28403 -5424 6 7.79185 41.3929 11.0465 3.42517 6.73563 9.75028 -5425 4 8.03468 40.5075 11.3396 -5.29569 0.405018 -3.04036 -5426 4 8.54504 0.0288503 11.3371 -5.83581 0.184768 -2.76634 -5427 6 48.7029 23.1861 34.0656 -21.7207 -4.36764 -18.9996 -5428 4 48.0685 22.9631 33.3267 17.6914 7.49561 22.5851 -5429 4 49.5647 23.2306 33.645 9.38657 -0.0360042 -3.96825 -5430 6 53.7171 23.5593 15.3279 7.98903 18.1369 9.52531 -5431 4 53.9889 24.0987 14.5512 -16.5338 -16.4319 -0.0123194 -5432 4 53.1679 22.8017 15.1046 0.0193492 2.24596 -12.2178 -5433 6 22.2331 5.62812 9.84443 -1.57081 2.06392 2.32933 -5434 4 21.8309 4.81719 9.48029 9.17546 11.008 0.0652314 -5435 4 22.6135 6.1669 9.11622 -10.9942 -17.7486 8.8339 -5436 6 33.6597 8.39756 9.07438 12.888 -3.30103 7.28088 -5437 4 32.9598 8.97334 9.38893 -12.3292 7.33717 0.65351 -5438 4 33.4682 8.16911 8.16186 -5.09418 6.09353 -6.44604 -5439 6 47.3119 37.7194 20.3363 21.5156 22.744 3.03657 -5440 4 47.6473 37.5407 19.4464 -9.46862 -8.33692 4.35957 -5441 4 46.6883 37.0359 20.5464 -12.6113 -19.4741 -3.99141 -5442 6 30.8566 16.7294 10.6197 -45.1927 -36.7422 15.3603 -5443 4 30.4293 17.2093 11.3782 10.0419 -7.15869 -15.9692 -5444 4 30.3248 15.8445 10.5087 28.8517 44.18 3.4025 -5445 6 48.1145 27.7388 10.1259 3.61398 12.7601 13.975 -5446 4 49.0121 27.5791 10.4269 8.16567 7.74751 7.8449 -5447 4 47.9875 27.049 9.49259 -14.0608 -13.1923 -17.2023 -5448 6 27.3333 38.6223 25.6028 2.23096 -19.4823 3.9502 -5449 4 28.2552 38.3493 25.5855 1.31221 -11.4567 4.08925 -5450 4 27.4115 39.4856 25.2253 -6.51803 21.9055 -3.11379 -5451 6 33.3641 5.73966 21.4502 -17.8674 16.1521 -18.7045 -5452 4 32.7333 6.1391 20.8022 11.3762 -13.0233 18.1576 -5453 4 34.2053 6.04196 21.1266 17.0109 2.35293 -3.511 -5454 6 25.3113 5.14231 4.52483 0.627568 -0.448638 -4.7772 -5455 4 25.9311 5.01166 5.26368 -5.83567 -1.85096 0.781095 -5456 4 24.4169 4.85751 4.79359 12.9854 0.158453 3.02285 -5457 6 40.4761 35.641 19.148 -1.79116 -1.08437 4.96155 -5458 4 40.617 35.2798 20.0294 1.97887 -12.6912 2.42284 -5459 4 40.4316 36.5735 19.3404 -1.08207 12.5153 -8.94186 -5460 6 49.6577 30.6259 19.0198 10.1565 -2.14928 -32.2041 -5461 4 49.9169 29.8714 18.4657 1.24638 0.0316256 -4.24874 -5462 4 49.4705 30.2089 19.8368 -7.31172 -12.6811 36.7039 -5463 6 42.1447 28.3235 17.0346 32.2065 -21.7575 -5.76428 -5464 4 41.8825 28.1658 16.1189 -9.06503 7.62036 -2.3435 -5465 4 42.9622 27.7534 17.0825 -24.1402 18.2728 2.552 -5466 6 47.7039 24.5139 36.3396 16.4403 6.39896 -6.79461 -5467 4 46.9537 23.9582 36.5487 -4.01092 -10.0931 -4.11437 -5468 4 48.0889 24.2445 35.4833 -10.0455 -7.86437 4.89019 -5469 6 19.3463 26.9837 19.8062 -14.9609 -0.640093 12.1457 -5470 4 19.5138 26.0435 19.7544 7.81166 -12.6546 -12.1749 -5471 4 18.7209 27.0489 20.5386 2.91516 7.38851 -4.99075 -5472 6 47.0534 26.8134 37.524 14.5946 -27.4581 20.3182 -5473 4 46.5999 27.4025 36.9765 -27.9132 42.868 -22.1392 -5474 4 47.3287 26.1433 36.896 5.92816 -9.16339 3.59921 -5475 6 9.30604 24.6864 40.2824 32.5721 -4.72803 4.84631 -5476 4 9.7425 23.8424 39.9878 -14.1318 19.2209 8.44319 -5477 4 10.0514 25.1942 40.7028 -19.8613 -12.5192 -10.8686 -5478 6 14.4861 17.9115 14.2864 12.9549 -2.10551 -8.28408 -5479 4 13.7677 18.2592 13.7435 1.92348 1.2648 2.86628 -5480 4 15.2633 17.8567 13.6783 -18.4643 2.67645 15.1406 -5481 6 37.1346 38.6824 18.7128 7.24689 -5.58535 -9.53541 -5482 4 36.7159 39.5508 18.578 6.84706 -0.690413 -9.37485 -5483 4 37.7177 38.457 17.9456 -10.6272 10.0511 7.65618 -5484 6 11.4119 5.91281 21.4549 8.51563 -6.63227 17.2429 -5485 4 12.0074 5.45436 22.0841 -12.0343 5.82261 -11.8758 -5486 4 10.9825 5.24051 20.9122 -1.087 -4.70833 -2.40093 -5487 6 4.25375 30.708 16.2346 29.3973 -34.9884 0.269827 -5488 4 4.09384 31.4404 15.6668 -11.3131 25.7038 -10.6546 -5489 4 3.7498 30.7826 17.0293 -13.4231 7.50595 13.7704 -5490 6 17.6719 16.0027 27.067 -23.8279 -26.0778 -36.6424 -5491 4 17.4271 15.046 26.968 10.0078 22.1048 9.82572 -5492 4 17.2008 16.3672 26.2667 15.5193 1.39518 21.9495 -5493 6 36.5109 8.65039 40.4308 12.8187 7.82554 4.51092 -5494 4 36.6212 9.57953 40.6523 1.70353 1.63484 0.0365135 -5495 4 35.6422 8.38915 40.7323 -7.59123 -4.26386 -1.28756 -5496 6 13.6114 12.9582 3.02589 -9.62347 -2.84414 10.0553 -5497 4 13.2363 12.4097 3.76862 19.3807 16.1747 -17.4749 -5498 4 14.4444 13.4268 3.2396 -7.87441 -9.64772 8.81761 -5499 6 38.5595 20.1494 21.6232 12.4359 -2.6335 16.4863 -5500 4 39.2259 20.3435 20.9591 -1.48691 0.443177 -6.45697 -5501 4 37.7118 20.0829 21.2013 -17.1516 -4.14152 -12.2545 -5502 6 50.9933 10.2578 30.842 -13.0607 -20.693 1.71035 -5503 4 51.4592 11.0512 30.6346 13.219 20.5706 -0.472754 -5504 4 50.4501 10.1493 30.0523 -4.00654 -4.85851 -2.78428 -5505 6 16.2749 2.41767 41.3132 30.43 46.2693 -10.4997 -5506 4 15.891 1.63581 41.6436 -18.412 -43.9133 0.0464609 -5507 4 16.2795 2.47169 40.3396 -9.09423 -14.5759 6.47164 -5508 6 16.5834 4.98938 41.8776 -7.21709 18.0228 -35.1788 -5509 4 16.7462 5.00964 0.881122 10.2158 10.5242 44.5139 -5510 4 16.3516 4.0781 41.7536 -3.71457 -12.9135 -9.58407 -5511 6 38.2173 37.6461 20.9885 34.7311 9.53448 3.02785 -5512 4 38.1039 38.1836 20.1861 -3.89758 -6.06348 6.62032 -5513 4 39.1638 37.7895 21.271 -30.6928 -4.57838 -6.40603 -5514 6 27.3006 1.89931 15.7822 -29.9599 0.296682 7.03709 -5515 4 27.5073 1.31215 15.0574 1.93116 -3.76907 -9.96281 -5516 4 26.3073 1.90747 15.8082 23.9237 -0.0762349 1.33551 -5517 6 29.0265 12.4386 37.8107 0.525722 -10.271 3.33822 -5518 4 29.5022 13.2884 37.7591 0.646351 -6.15481 8.15455 -5519 4 29.2991 11.9227 38.6151 -0.523918 21.8031 -11.8471 -5520 6 46.0742 20.1649 18.9021 10.3528 7.89056 -10.7305 -5521 4 45.1842 20.5502 18.8696 3.90233 0.901411 -3.14496 -5522 4 46.6469 20.7119 18.3183 -8.66547 -7.99067 8.59505 -5523 6 2.04022 38.6829 18.5084 -2.98341 9.82285 -40.3455 -5524 4 2.90324 38.7749 18.9245 -0.612017 -3.29975 20.9344 -5525 4 1.3228 38.3823 19.0758 6.43327 -3.78011 20.6074 -5526 6 44.0503 24.9822 25.9794 4.67294 -4.59524 3.88497 -5527 4 44.3373 24.0607 26.0767 4.76241 4.2408 6.41339 -5528 4 43.5759 24.9717 25.1449 -4.92835 3.44315 -2.97359 -5529 6 5.98031 26.6293 4.53551 9.30387 5.64625 14.1271 -5530 4 6.57491 27.1353 5.14729 -11.3776 -17.0368 -12.135 -5531 4 6.21313 25.677 4.5841 -4.82905 19.4284 -2.02229 -5532 6 0.0924267 23.2133 10.9333 1.42961 0.53672 3.80218 -5533 4 0.717354 23.7388 10.4004 2.9288 -9.65077 10.1872 -5534 4 0.580921 22.6863 11.5989 -3.01683 9.30052 -9.37626 -5535 6 39.1222 20.6154 12.8741 28.3348 2.95161 0.461931 -5536 4 40.0468 20.8249 13.1753 -23.4009 -9.33487 -2.82098 -5537 4 38.9932 21.1408 12.0685 -0.0080483 -0.226832 2.68059 -5538 6 39.959 39.9495 18.871 8.01281 1.93571 -21.8826 -5539 4 39.6441 40.4313 18.0693 6.09748 -11.7745 18.4856 -5540 4 39.3412 40.1359 19.5607 -16.2687 5.42221 11.8382 -5541 6 49.288 23.0046 30.5128 21.2206 -9.75551 18.5897 -5542 4 49.5389 23.7528 30.0013 -1.98497 24.1116 -29.9204 -5543 4 49.9896 23.0569 31.1809 -5.40626 -11.587 6.30696 -5544 6 10.3545 2.34292 9.14765 -20.562 40.259 12.8074 -5545 4 10.1012 1.5797 8.68555 -3.02669 -36.876 -18.9145 -5546 4 9.58966 2.94108 8.9894 20.4134 -0.423974 9.05106 -5547 6 9.6115 40.9317 19.7379 12.0905 -27.6191 -4.08509 -5548 4 9.69139 40.7751 18.7589 3.32448 -0.840478 24.839 -5549 4 9.96472 40.0953 20.2033 -15.7711 32.9781 -27.126 -5550 6 29.2535 5.10379 17.4957 6.62295 15.7752 6.05206 -5551 4 28.9547 4.7998 16.6324 -1.76299 0.290572 -5.22762 -5552 4 29.5626 6.02275 17.3534 -3.29284 -14.1281 1.20249 -5553 6 27.0956 15.411 3.22262 8.43004 -47.4217 3.28637 -5554 4 27.2677 16.3043 3.38591 1.16524 52.1129 6.18754 -5555 4 27.741 14.9724 3.82188 -13.792 3.46242 -10.72 -5556 6 32.8341 39.3821 25.1177 -1.66938 -44.1854 21.376 -5557 4 32.6253 40.2767 24.9331 -7.27917 31.8978 1.68524 -5558 4 32.4689 39.1753 26.0219 6.68592 11.3878 -26.9617 -5559 6 34.9613 7.8883 31.2358 4.6626 36.0744 6.61898 -5560 4 34.1778 8.39814 31.5057 7.62156 3.23778 -2.6687 -5561 4 34.6431 7.01199 31.2355 -6.57887 -35.8668 -2.78431 -5562 6 6.13276 36.7597 26.1434 10.8988 16.6869 20.3463 -5563 4 6.63888 37.4372 26.6797 -12.2659 -21.448 -21.9021 -5564 4 6.61066 36.5785 25.3331 5.0666 0.722926 -2.43587 -5565 6 6.00975 25.8323 24.1014 -4.47961 0.932019 -2.36624 -5566 4 6.35352 25.3647 24.9068 -18.3984 14.8695 -13.0656 -5567 4 5.16189 26.3111 24.2876 18.65 -15.8322 7.58859 -5568 6 45.6302 24.3945 2.56021 19.8484 -5.54431 -0.0961329 -5569 4 46.4674 24.0527 2.19931 -2.34639 0.0383291 -2.49188 -5570 4 45.6784 24.1611 3.48508 -4.52597 -1.56916 11.2469 -5571 6 15.5147 11.7041 32.683 14.9804 20.126 19.7749 -5572 4 15.7333 12.537 33.1619 -4.31998 -20.325 -9.45866 -5573 4 14.9494 12.0119 31.9786 -9.0483 1.88099 -11.1618 -5574 6 46.4109 17.7015 37.4781 -27.0258 -32.7931 -28.9932 -5575 4 46.5427 17.8951 38.3867 3.19976 6.65122 29.0636 -5576 4 45.8763 16.8534 37.4192 15.4316 28.8096 -0.764517 -5577 6 39.7197 20.9143 18.534 -24.0731 20.2285 32.8184 -5578 4 40.3775 20.5463 17.9571 20.7324 -0.0260386 -6.5243 -5579 4 40.0771 21.5962 19.1648 -0.0511872 -19.8333 -22.8182 -5580 6 23.8035 28.041 36.6748 9.0016 14.1447 -6.24075 -5581 4 23.3139 27.2938 37.064 2.44252 16.2828 7.25552 -5582 4 23.789 28.845 37.2599 -7.88527 -27.7019 -2.97202 -5583 6 23.2344 0.634844 30.8976 -0.384503 -14.0448 -5.97485 -5584 4 23.3889 41.8653 31.5825 6.30765 2.44689 -9.38002 -5585 4 23.8441 0.49945 30.133 -8.72578 -2.57312 14.648 -5586 6 37.1436 6.89172 28.2858 -3.37167 6.44507 30.6351 -5587 4 36.8056 6.23733 28.9583 11.2574 17.9183 -21.3683 -5588 4 37.4325 7.68669 28.8192 -8.94015 -21.4647 -17.7418 -5589 6 3.23535 6.60909 12.3935 -1.87368 1.73448 8.36027 -5590 4 3.03832 6.9284 11.4867 8.20532 -9.84476 7.71099 -5591 4 3.52123 5.67427 12.3822 -6.77188 11.8795 -6.70084 -5592 6 12.6173 19.1518 31.1213 -5.69854 -18.2223 8.29425 -5593 4 12.5903 18.2248 31.5183 -0.203161 27.8336 -18.7857 -5594 4 12.2771 19.1425 30.2049 2.23067 -5.60852 14.6148 -5595 6 15.1884 38.3149 41.5578 -3.57026 -0.303434 0.776802 -5596 4 15.4085 38.7623 40.7331 -1.55695 3.41656 0.7558 -5597 4 16.0064 37.8692 41.7958 4.70682 -3.66196 2.37744 -5598 6 49.6308 33.3399 19.6427 -23.754 -26.2674 -4.71234 -5599 4 48.6425 33.4171 19.8493 35.7001 -9.4047 -10.4581 -5600 4 49.8006 32.395 19.3286 -9.63678 35.3831 11.1391 -5601 6 6.36026 2.78098 29.8944 3.74937 13.951 -9.77631 -5602 4 6.39713 3.75696 29.8119 -0.635871 -14.0149 2.80012 -5603 4 6.09114 2.63212 30.8044 -1.55083 -4.44243 9.60337 -5604 6 13.1715 31.7798 30.2783 -11.6407 3.9064 -21.9894 -5605 4 12.793 31.9725 29.3819 8.72012 -0.590438 18.6573 -5606 4 12.9685 30.8401 30.4245 2.82441 5.28785 4.26217 -5607 6 32.3245 32.246 24.8932 -0.334642 -17.4514 3.51608 -5608 4 32.5833 31.3985 24.4266 1.55373 29.7789 3.70352 -5609 4 32.7413 33.0821 24.5914 4.2936 -14.9539 -9.40787 -5610 6 41.9919 14.5701 37.4124 -31.8928 -38.2057 -11.1184 -5611 4 41.1925 13.9916 37.278 11.7187 28.3557 2.93562 -5612 4 42.6351 13.8531 37.4242 20.2579 6.94588 1.70752 -5613 6 11.8923 7.24234 27.6655 -13.1666 -25.4093 6.94854 -5614 4 11.7936 6.42612 28.2118 8.91213 18.8361 -2.40188 -5615 4 11.255 7.06027 26.9538 4.64331 9.73453 -0.841263 -5616 6 14.1973 37.538 6.88791 4.07782 -38.2298 -28.3639 -5617 4 14.4575 38.4426 6.80778 6.05638 30.4198 1.96843 -5618 4 14.5936 37.1092 6.07523 -12.6749 10.0326 27.426 -5619 6 14.2479 30.6948 36.0545 7.37408 36.4971 9.0133 -5620 4 14.3981 30.7629 35.1101 2.39159 -10.6067 -11.9788 -5621 4 14.1779 29.7876 36.2972 -1.09854 -35.7585 -0.14866 -5622 6 16.4334 33.6494 5.49228 -9.96541 -28.1856 -5.39099 -5623 4 16.7983 34.5397 5.45321 9.37649 -3.55324 -12.1003 -5624 4 16.7788 32.9912 4.81355 -0.655183 31.9156 12.6517 -5625 6 23.0317 17.1547 7.8473 13.6053 -0.132883 9.10362 -5626 4 22.1841 17.362 7.40272 9.91908 10.567 10.3381 -5627 4 23.4804 17.9296 8.30446 -24.7767 -19.3244 -18.4116 -5628 6 51.7425 20.8913 27.7088 32.6403 -5.30395 6.54704 -5629 4 51.4526 20.615 28.6066 9.31531 5.01366 -13.1678 -5630 4 52.7523 20.9899 27.7096 -40.0215 -4.95426 2.55021 -5631 6 2.19474 27.6072 28.8013 -23.9703 3.8216 12.4498 -5632 4 2.89306 28.2617 29.0045 8.22653 -14.998 -10.5048 -5633 4 2.42593 26.8662 28.2089 10.4722 10.3682 5.46115 -5634 6 17.2069 14.3387 7.70681 0.210359 -30.5014 22.2216 -5635 4 16.8342 14.1932 8.62484 13.2745 1.87397 -27.442 -5636 4 17.791 13.5503 7.49447 -17.8498 26.4292 5.4189 -5637 6 12.462 8.93964 14.7065 0.798528 8.71873 -6.67623 -5638 4 12.2438 7.98523 14.5568 11.6803 11.8078 17.0064 -5639 4 13.0577 9.12873 15.4809 -12.5262 -17.6243 -12.8578 -5640 6 42.4139 38.0579 9.76413 -20.5008 17.2265 16.0611 -5641 4 43.2035 37.8944 10.2554 20.3834 -6.45835 6.72371 -5642 4 41.8905 38.6035 10.3913 3.31942 -7.4886 -15.3201 -5643 6 51.8227 30.3513 28.272 -27.6927 -20.9124 31.2363 -5644 4 51.4089 31.1514 27.9711 0.163888 16.7369 -10.597 -5645 4 52.6546 30.2313 27.8441 24.1641 3.9866 -16.3823 -5646 6 0.181148 18.531 4.58976 -5.95747 22.8787 14.3331 -5647 4 0.30783 18.164 3.72574 1.94264 -10.8238 -19.8991 -5648 4 0.385506 17.861 5.23812 2.38695 -15.8688 4.81738 -5649 6 34.1492 0.61754 2.99129 -49.6439 4.42439 -16.0687 -5650 4 33.2398 0.938351 2.63038 43.5613 -10.8791 15.5023 -5651 4 34.8325 1.13587 2.566 3.67212 10.3309 -6.27046 -5652 6 49.171 17.2374 23.1529 12.6877 -22.0026 -17.2704 -5653 4 50.1002 17.5391 23.0823 -12.4494 -3.65532 2.68691 -5654 4 49.1558 16.3609 22.6932 2.16788 22.8154 9.36775 -5655 6 23.1488 6.5083 23.6124 -20.5997 37.6057 -45.0229 -5656 4 23.0491 7.12001 22.8007 18.1878 -21.95 27.0503 -5657 4 22.2316 6.45775 23.8939 -1.28085 -6.53623 13.7239 -5658 6 11.0806 24.0842 29.2705 -8.73998 -10.3514 -18.9502 -5659 4 11.2441 23.4599 28.5168 0.0150655 10.4905 16.9308 -5660 4 11.7296 23.9083 29.9561 7.87164 -2.5542 2.12029 -5661 6 36.5429 4.08242 21.672 0.786556 -8.94696 -15.3954 -5662 4 36.4501 4.49554 22.5359 -3.35109 8.47972 1.84417 -5663 4 36.356 4.76727 20.9996 1.47044 -5.20042 11.1851 -5664 6 31.3053 25.6355 24.591 -3.66138 3.71718 3.54675 -5665 4 31.1335 26.2845 25.3159 5.93159 -20.4343 -13.8963 -5666 4 32.0778 25.0682 24.8002 -7.66178 11.3294 7.22687 -5667 6 42.6065 23.0403 14.7613 -16.8309 4.03618 -45.3098 -5668 4 42.9655 23.4598 13.9577 -8.276 -4.36486 -1.00498 -5669 4 43.204 23.3098 15.4118 29.6291 10.3091 46.448 -5670 6 14.3159 11.6727 8.8813 -14.5655 -17.9373 -12.2817 -5671 4 13.3434 11.4421 8.85146 29.9821 6.96631 -2.22077 -5672 4 14.7728 10.9717 8.34565 -11.3371 15.3318 14.175 -5673 6 21.498 2.14139 3.39648 14.7702 -17.8734 -6.06988 -5674 4 22.405 2.21099 3.73647 -11.0312 3.8274 -0.37696 -5675 4 21.4855 1.24815 2.9799 -4.51333 14.3419 9.54204 -5676 6 22.4606 27.6741 39.0725 -9.38699 -8.57051 -12.0691 -5677 4 22.9487 28.2157 39.6788 9.87489 12.9386 7.45564 -5678 4 22.251 26.9021 39.5804 -3.7481 -10.0177 3.53978 -5679 6 37.2705 33.4961 30.0614 -4.9469 -17.1986 11.1636 -5680 4 36.5019 32.9393 30.3108 14.0133 8.69925 -1.52787 -5681 4 38.0636 33.0902 30.4641 -13.5236 2.40347 -6.71067 -5682 6 41.8394 20.8621 40.0097 -20.8091 -17.9415 -11.9484 -5683 4 40.8821 20.7467 40.2088 17.4772 5.45688 -4.89215 -5684 4 42.2425 21.2111 40.795 8.11745 4.61319 15.3924 -5685 6 10.0509 31.1054 22.2556 20.3961 -18.8014 17.2446 -5686 4 9.98499 30.8639 23.2007 -4.95143 3.66172 -13.3958 -5687 4 9.23459 31.4918 21.9926 -24.2979 8.76968 -3.95477 -5688 6 24.2243 35.3747 6.62617 -9.42531 -3.96828 -6.7527 -5689 4 23.2865 35.2144 6.56466 -9.91939 -6.68958 -24.4488 -5690 4 24.2401 35.6133 7.54088 22.4532 10.3619 17.5563 -5691 6 54.2249 13.3694 18.759 -24.737 -0.349871 -1.41807 -5692 4 53.5933 13.3703 18.006 15.3609 1.78219 9.05355 -5693 4 53.6566 13.499 19.5435 10.7967 -0.400371 -8.89572 -5694 6 12.4855 25.1013 17.4456 -6.57337 13.5018 5.68311 -5695 4 11.9686 25.7405 17.9864 9.67417 -13.0798 -6.23069 -5696 4 12.9177 24.4729 18.0482 -8.67745 6.31928 -4.55572 -5697 6 22.3956 33.969 18.8874 -5.8063 -1.6479 -7.81353 -5698 4 22.8035 34.4497 18.1359 -8.0332 -6.19684 5.18696 -5699 4 21.6693 33.408 18.5182 22.6878 13.045 2.20471 -5700 6 24.4435 12.9292 5.84415 8.74588 -19.8564 16.0901 -5701 4 24.6262 13.8512 5.99703 -0.326218 20.1414 -4.57271 -5702 4 23.8078 12.8376 5.13214 -2.90401 5.95194 -4.82348 -5703 6 13.3959 11.2335 28.6038 -6.74888 -5.61354 -5.54718 -5704 4 13.7674 10.4842 28.0847 -9.93712 8.82772 12.9583 -5705 4 12.6218 10.8864 29.0903 8.08376 -4.51111 -11.0518 -5706 6 20.9645 34.7015 21.139 -6.51648 1.45471 -0.425004 -5707 4 21.4543 35.0255 21.9119 2.52902 -3.67403 -7.94594 -5708 4 21.5071 34.7067 20.3201 -1.1119 -0.149268 16.7291 -5709 6 37.136 34.5081 26.161 6.62209 -8.97684 -22.2932 -5710 4 37.2438 34.333 25.2112 -5.73965 -6.14541 10.65 -5711 4 37.5173 35.375 26.2088 1.33918 12.2816 12.8311 -5712 6 49.3593 27.1123 23.4681 27.9614 -13.0657 2.71617 -5713 4 48.46 27.3383 23.3348 -38.0547 10.3981 -3.53627 -5714 4 49.5827 26.632 22.6632 1.14175 -6.15755 -6.01297 -5715 6 2.6463 41.7198 27.6524 7.3894 17.9878 -25.5957 -5716 4 2.49639 41.7504 26.6775 -8.79282 -10.4379 14.5056 -5717 4 3.38399 0.440368 27.7439 -10.0848 -7.80081 10.7778 -5718 6 28.2486 5.66281 0.851705 -28.2484 -11.3463 5.20358 -5719 4 29.1342 5.88017 0.643235 30.8656 11.4658 -5.99415 -5720 4 28.269 4.69693 0.891643 -4.88577 1.64465 1.4719 -5721 6 46.3319 19.9354 30.6504 10.2867 19.401 8.99033 -5722 4 46.9123 19.9353 29.8821 -3.84989 -4.07474 -6.11394 -5723 4 46.5975 20.7732 31.0971 -12.3274 -18.5124 -2.17733 -5724 6 3.63748 25.7835 21.5531 -13.3498 -8.40935 -29.3244 -5725 4 3.82697 24.8656 21.7578 10.5845 0.467441 11.0774 -5726 4 3.24958 25.6945 20.6565 5.98204 10.7305 11.6574 -5727 6 2.75525 19.0991 29.6309 -15.3907 3.66354 13.2976 -5728 4 3.52302 18.6052 29.9384 7.69741 -2.11378 -3.28897 -5729 4 2.98375 19.5594 28.8227 11.6258 3.58084 -5.99316 -5730 6 11.8998 35.7779 24.2574 -1.81403 7.91701 -5.71356 -5731 4 12.4147 34.9912 24.3376 10.7342 -20.9531 7.85436 -5732 4 12.5443 36.3811 23.8879 2.19538 16 -3.69366 -5733 6 52.3427 30.4062 14.294 22.5839 4.39347 1.37497 -5734 4 52.8745 31.0934 14.7488 -8.66891 -1.23278 -4.46489 -5735 4 51.4935 30.7804 14.0876 -13.5204 11.8147 1.32314 -5736 6 0.0822874 24.3672 32.1291 -8.34182 -9.5272 -6.40877 -5737 4 0.828194 24.8082 31.7001 -5.59692 5.0286 6.41936 -5738 4 -0.0482457 24.7479 33.0025 4.35174 8.79498 5.58774 -5739 6 31.4966 23.7292 38.8152 19.1094 38.0757 -4.99319 -5740 4 31.5999 23.5133 39.7508 -8.21927 -12.2318 -1.63758 -5741 4 30.9751 23.0699 38.3783 -13.0662 -23.7861 4.62116 -5742 6 52.1169 21.6052 3.50792 14.3711 -14.904 -13.5765 -5743 4 52.8807 21.6364 2.89306 -16.3122 -4.91238 6.22228 -5744 4 52.1257 22.4771 3.8768 -2.65107 18.1744 9.91254 -5745 6 31.7478 33.9414 11.5999 6.40399 -14.705 -7.35618 -5746 4 31.326 34.316 12.3745 -3.98661 3.76902 9.36008 -5747 4 32.1024 33.0666 11.8569 -5.74966 15.1553 -0.43871 -5748 6 7.04869 17.6722 16.6738 15.5169 9.78585 -46.6303 -5749 4 6.86408 17.1452 17.4554 -1.12856 -17.4359 1.80272 -5750 4 7.18951 17.0724 15.8577 -9.09698 16.5018 49.1326 -5751 6 51.856 41.8666 22.1892 3.84753 25.5265 -21.3427 -5752 4 52.3772 41.4924 22.8897 9.65371 -13.9556 16.5062 -5753 4 51.0512 41.3628 22.1522 -12.8828 -14.9996 6.2925 -5754 6 50.8708 9.92691 25.9357 -19.3562 -16.2947 3.52683 -5755 4 50.5833 10.1225 25.0455 -2.85771 2.39787 -5.58996 -5756 4 51.6551 10.4289 26.0882 17.2727 16.0662 4.10656 -5757 6 8.99927 39.8664 13.8488 -8.14038 -13.6283 -23.156 -5758 4 9.59929 39.3497 14.3885 6.06913 -3.61279 3.55219 -5759 4 8.79522 39.3067 13.0547 7.60199 16.2117 22.1745 -5760 6 40.7023 25.5302 0.148896 6.79038 -13.4508 8.01702 -5761 4 40.3789 25.4701 1.07476 14.4856 1.96217 -11.1718 -5762 4 41.6802 25.6099 0.149801 -17.1473 -2.90233 2.89792 -5763 6 46.6909 7.84537 22.8702 9.17253 9.27189 2.7581 -5764 4 46.223 7.4121 23.6122 6.69651 11.5962 -1.82232 -5765 4 47.0858 8.70418 23.1544 -10.5797 -14.2101 5.83025 -5766 6 21.013 12.9106 9.96683 -11.4772 33.9385 12.3935 -5767 4 21.4714 12.292 10.5062 17.1864 -22.5118 18.142 -5768 4 21.2487 12.7153 9.07972 8.38308 -10.8862 -30.7653 -5769 6 24.8549 0.515446 28.6008 5.68052 19.4063 -7.13145 -5770 4 24.6132 0.0822417 27.7678 -2.25298 -0.561161 -0.933523 -5771 4 24.9931 1.46483 28.3802 -3.69568 -16.6941 4.65055 -5772 6 9.93738 22.6806 8.27387 -17.0851 30.8612 6.83622 -5773 4 10.4469 21.9921 7.84938 5.97494 0.327216 -18.4105 -5774 4 9.65147 23.3826 7.61609 12.4321 -25.0338 8.46255 -5775 6 33.2759 9.25001 23.8237 4.47891 -44.2955 15.8461 -5776 4 33.2652 10.105 23.448 0.909732 36.8069 -18.0196 -5777 4 34.1325 8.84557 23.5962 -5.93924 6.51534 1.57833 -5778 6 47.795 20.3665 34.2866 5.36639 25.6433 -13.2606 -5779 4 47.2589 21.0165 33.753 7.81309 -27.8153 16.882 -5780 4 47.2984 19.5618 34.502 -10.2742 8.68957 -7.27829 -5781 6 7.49437 13.498 41.0843 -1.51987 -1.91843 -16.5508 -5782 4 7.4491 13.1887 40.147 4.71488 4.53153 18.247 -5783 4 8.31974 13.1617 41.4819 -4.68073 -1.19795 -7.02436 -5784 6 9.95832 23.5973 1.60681 5.21402 2.49741 5.68021 -5785 4 10.4402 24.1882 0.998507 -5.12041 -6.82862 1.89989 -5786 4 9.65493 22.8254 1.1174 1.14228 -2.219 -8.51506 -5787 6 27.3184 14.1623 11.3341 -13.0256 18.3326 19.191 -5788 4 27.0532 14.8043 10.6617 -0.288735 -3.87647 -1.15481 -5789 4 27.1082 14.6278 12.1878 10.7132 -11.7932 -20.1286 -5790 6 25.8363 31.783 17.8928 12.257 -31.4953 -8.75538 -5791 4 26.5912 31.2312 17.6268 -16.3657 -3.28218 2.7807 -5792 4 26.257 32.5845 18.0942 8.13437 40.9862 10.9181 -5793 6 28.5106 34.3419 0.227626 33.3873 17.7784 12.057 -5794 4 28.9852 33.8482 0.904042 3.3493 0.859906 2.37016 -5795 4 27.7339 33.8559 0.0766936 -35.6263 -19.3635 -8.63216 -5796 6 39.4752 27.6784 22.7097 42.3367 15.2059 -23.9811 -5797 4 38.5679 27.9307 22.8105 -22.3645 11.7157 0.32019 -5798 4 39.9498 28.4084 22.1978 -16.9125 -22.6846 16.1018 -5799 6 19.4034 35.5119 37.6428 33.5095 -11.1022 16.798 -5800 4 18.7953 34.9333 37.2031 -16.031 -7.23993 -11.3762 -5801 4 20.0399 34.8524 38.0282 -15.2165 20.9239 -9.15559 -5802 6 40.2577 30.223 10.7322 40.2352 -13.6393 -47.8395 -5803 4 40.0003 30.153 11.624 -20.3139 3.96126 40.955 -5804 4 39.7054 30.7997 10.2038 -14.6911 14.5022 3.62333 -5805 6 44.8252 28.467 36.0943 -27.9317 -39.6182 20.2271 -5806 4 44.1 27.9067 36.617 42.0807 42.9759 -26.5645 -5807 4 44.8315 29.4044 36.3472 -5.71594 -8.07431 0.279077 -5808 6 17.9328 13.9421 34.2756 -23.0398 37.6904 -16.8553 -5809 4 17.2847 14.658 34.0723 21.6532 -14.16 -3.36915 -5810 4 17.4769 13.4978 34.9742 -2.33669 -21.4636 20.9706 -5811 6 22.7722 11.8049 25.9053 18.1639 13.4769 -8.32772 -5812 4 22.5143 10.954 26.1764 -32.0329 -27.8082 11.3637 -5813 4 23.7113 11.6387 25.939 19.9678 17.8754 -6.33473 -5814 6 27.9844 31.9785 40.3628 4.4159 -7.73511 16.6787 -5815 4 28.3104 32.752 39.9101 2.36742 5.81951 -9.83175 -5816 4 27.6866 31.3262 39.7216 -3.89657 2.92736 -3.90823 -5817 6 29.7056 5.13899 29.6966 36.1554 -28.1732 -9.81385 -5818 4 29.3242 5.52633 30.4675 -11.5775 13.5815 21.5043 -5819 4 30.5867 4.74321 29.9895 -34.1051 15.4003 -14.984 -5820 6 3.10893 21.4798 2.76501 -7.99866 -19.5262 -7.43282 -5821 4 2.82658 22.3873 2.73831 -4.86294 14.1814 1.21532 -5822 4 2.47005 21.0041 2.20282 6.80672 4.92349 5.4824 -5823 6 13.6497 30.6638 39.7451 -45.1888 -1.5 -27.4221 -5824 4 14.5316 30.8766 39.996 26.4643 7.88404 -4.33129 -5825 4 13.4124 30.9677 38.8135 13.6057 -6.06521 34.9266 -5826 6 39.188 23.0895 28.2562 15.2318 22.185 -40.3341 -5827 4 39.2961 23.1894 27.2636 -4.5014 -1.37473 28.8386 -5828 4 38.6302 22.3345 28.3879 -14.2617 -17.3372 5.24228 -5829 6 16.9988 23.7489 0.769214 20.7079 -15.4466 5.05665 -5830 4 16.2107 23.4786 1.24898 -3.68938 2.33828 -2.20359 -5831 4 17.6949 23.1909 1.19915 -10.9726 17.7258 -9.6056 -5832 6 0.328251 33.6592 13.0294 5.05621 13.0457 -18.8804 -5833 4 55.0348 32.9975 13.677 0.78154 12.2617 9.8199 -5834 4 0.388277 34.5816 13.3997 -6.36603 -34.6234 2.68168 -5835 6 49.1005 40.6595 16.9496 -9.76098 4.73909 -13.8177 -5836 4 49.2151 40.9775 16.0207 -4.23419 -6.48803 14.4163 -5837 4 48.1506 40.7848 17.1408 8.79948 2.71791 -6.65809 -5838 6 52.1337 39.9918 15.1756 26.7545 10.0433 -2.50902 -5839 4 51.9708 40.0067 16.1202 -6.38877 -4.81519 5.40892 -5840 4 51.3465 39.7494 14.7166 -22.4824 -4.17003 -7.64187 -5841 6 29.052 37.1033 37.836 19.097 -0.968932 -4.5801 -5842 4 29.682 36.5364 38.3049 -8.87198 1.40853 -5.4338 -5843 4 28.3717 37.2982 38.474 -12.8547 4.6316 9.68073 -5844 6 4.87585 1.47991 27.5772 1.0193 4.57332 -1.4391 -5845 4 5.21258 1.06654 26.7686 1.92757 2.57678 7.5628 -5846 4 5.62617 1.67061 28.1638 -3.61661 -2.55781 -2.1886 -5847 6 43.5959 24.3463 30.211 -19.7182 -5.92862 14.3815 -5848 4 44.3514 23.9347 29.8066 13.2495 -10.0411 -7.84874 -5849 4 42.954 23.6392 30.3929 6.93549 5.0637 -4.64144 -5850 6 33.7524 3.52358 22.9355 4.65558 -3.45748 -24.1115 -5851 4 34.2253 2.7722 22.5212 -9.10678 14.6802 11.3369 -5852 4 33.6063 4.18077 22.2154 2.29559 -11.8514 17.7295 -5853 6 19.8909 13.4517 25.3922 5.25873 -5.74859 -7.9771 -5854 4 20.5096 14.0736 25.7535 5.66529 16.002 2.33546 -5855 4 19.9521 12.7313 26.0185 -3.34295 -15.2779 0.0169051 -5856 6 47.3737 23.1767 39.6212 -5.95621 11.0118 4.46955 -5857 4 47.7191 22.5265 39.0041 4.75348 -8.18234 -7.77672 -5858 4 47.7813 24.0201 39.3891 1.84918 -0.94156 0.213564 -5859 6 20.1771 18.6734 32.3906 -2.68035 -24.6067 18.319 -5860 4 19.7167 19.3347 31.8914 0.274713 15.8779 -14.5216 -5861 4 21.1289 18.7867 32.3383 1.39014 4.37005 -4.23212 -5862 6 0.462706 5.80795 25.6713 -7.84599 -7.21428 -45.242 -5863 4 0.323825 6.56383 25.0471 7.25451 -11.4554 20.6165 -5864 4 0.632949 6.14438 26.5418 1.37183 20.4375 17.7538 -5865 6 6.87393 19.55 31.9207 -32.7339 30.668 -22.5905 -5866 4 6.24577 19.9891 32.5577 15.6688 -11.8235 -17.9631 -5867 4 6.64633 19.9665 31.0139 13.7505 -20.7976 33.8805 -5868 6 6.72837 20.2799 38.5105 -3.64262 3.78431 -13.5507 -5869 4 5.92588 20.8248 38.5086 9.85336 -2.70512 -1.72466 -5870 4 6.83039 19.9897 39.4188 -3.49896 1.12624 1.5432 -5871 6 22.0356 25.927 12.2605 -11.8373 -4.76705 -8.63625 -5872 4 21.2326 25.5939 11.7351 40.6868 7.42656 16.975 -5873 4 22.8707 25.497 11.9923 -13.8486 -7.11072 -10.1952 -5874 6 39.3057 7.93299 2.64755 -0.118713 9.42534 0.0803503 -5875 4 39.6638 8.10481 3.53463 2.86319 -1.68774 -0.268253 -5876 4 39.5974 7.06378 2.35963 5.09861 -8.7519 2.38745 -5877 6 29.9647 22.0457 34.4057 2.14844 7.25734 -28.1517 -5878 4 30.9338 21.915 34.3365 -18.2911 3.03872 -0.832433 -5879 4 29.6238 22.2503 33.4865 4.56359 -4.84177 28.516 -5880 6 37.5951 16.2788 0.369586 8.64826 -19.3515 -0.400608 -5881 4 37.1939 15.3927 0.526929 9.97291 14.3398 -5.3998 -5882 4 38.4404 16.082 41.8172 -10.5319 -0.823814 4.55326 -5883 6 11.7218 13.8845 21.8896 14.7882 -39.2126 -46.5495 -5884 4 11.9305 13.3995 21.0267 -7.58848 27.5443 23.8472 -5885 4 11.7147 13.1405 22.4934 -2.11531 -1.20748 18.2217 -5886 6 33.352 10.9238 27.6262 4.19409 14.5082 -21.7958 -5887 4 32.741 11.5866 27.2704 3.79692 -6.80494 8.02232 -5888 4 34.0591 10.8732 26.9373 -11.2958 -2.76298 18.1193 -5889 6 30.9422 36.5217 10.1011 0.546516 -38.0529 -7.53065 -5890 4 31.037 36.4313 9.10316 -3.7795 -1.86296 33.6151 -5891 4 30.9555 35.5897 10.5034 1.2522 32.9448 -19.5962 -5892 6 45.5828 6.56917 25.2425 13.4794 -38.3135 -0.0969536 -5893 4 44.6735 6.51564 25.4913 -20.1668 12.9455 3.79285 -5894 4 45.8221 5.605 25.2656 2.31227 28.4662 -4.04899 -5895 6 9.53612 30.0233 12.041 13.8898 -20.9008 -19.4413 -5896 4 9.92894 30.5763 11.3437 -1.97905 0.820167 2.98642 -5897 4 9.13364 30.6129 12.6538 -15.721 17.9312 16.9413 -5898 6 53.0747 24.9738 1.38132 -1.86355 2.7084 19.7503 -5899 4 52.7154 24.2509 0.898374 -13.0694 -24.4059 -9.99565 -5900 4 53.2522 25.5795 0.686793 9.94881 23.634 -11.856 -5901 6 26.1984 24.7352 0.509304 -7.53082 -0.727442 -26.3589 -5902 4 25.609 24.783 41.6367 17.1237 -12.5609 6.929 -5903 4 25.7967 25.3842 1.06587 -1.32139 13.3231 25.2347 -5904 6 23.0109 2.41889 11.5345 -1.81733 -0.917938 -19.7561 -5905 4 22.156 2.16845 11.9124 1.98231 0.963836 1.10425 -5906 4 22.831 2.471 10.5696 1.38956 0.195961 11.1121 -5907 6 29.9165 12.8947 31.0013 41.0722 8.15666 -12.068 -5908 4 30.8272 12.8901 31.3843 -23.6061 -3.22469 3.62361 -5909 4 30.1671 13.0589 30.0659 -21.5099 -4.3955 11.2257 -5910 6 24.0423 16.1922 40.3682 -11.7161 -52.7791 -12.7633 -5911 4 23.7963 16.7427 41.0863 -4.03022 37.1909 22.8519 -5912 4 24.4513 16.6836 39.6566 3.29428 17.0417 2.56802 -5913 6 21.8759 29.9137 12.7377 16.7673 9.38207 5.68416 -5914 4 21.0615 29.603 12.3447 -12.732 2.54077 -5.12984 -5915 4 21.8572 30.8889 12.7388 -3.49843 -10.2696 0.0943897 -5916 6 45.2049 12.2865 6.6319 2.92472 30.2037 5.62675 -5917 4 45.4908 11.5347 6.14771 0.0808414 -27.1796 -10.0093 -5918 4 45.9331 12.9133 6.49804 -8.49251 3.31449 4.74769 -5919 6 7.58748 25.3948 38.035 37.4402 -5.69153 16.1754 -5920 4 8.20159 25.1941 37.2709 -20.479 6.14302 24.9331 -5921 4 8.13335 25.2556 38.8857 -20.6102 5.92378 -35.7711 -5922 6 46.1732 7.83303 16.6988 4.4841 14.5494 -17.535 -5923 4 46.5452 7.84101 15.8027 -9.24205 10.2202 -0.760543 -5924 4 46.6945 7.14485 17.0776 9.771 -19.5689 22.069 -5925 6 54.9675 12.85 7.71106 -14.5426 11.3809 9.40253 -5926 4 54.9732 13.8139 7.75484 8.59467 -0.566973 -8.90089 -5927 4 54.3786 12.658 8.45528 8.25441 -10.7611 -5.52346 -5928 6 26.93 39.6729 37.1759 35.4319 -17.0193 24.0328 -5929 4 27.7049 39.4447 36.6239 -16.3058 8.04164 -6.8945 -5930 4 27.2164 39.2553 38.0316 -23.1866 12.5553 -17.3208 -5931 6 27.0277 8.92497 38.0115 25.8258 -15.1538 -19.4143 -5932 4 26.3205 9.53863 38.1727 -14.2244 17.8778 -0.0983549 -5933 4 27.5327 9.26244 37.2322 -14.307 -2.33761 14.5508 -5934 6 8.04621 7.65921 29.9125 5.96085 -8.8046 12.0925 -5935 4 8.66182 7.92407 30.6202 -6.26406 -0.422529 -8.96361 -5936 4 7.80891 8.46925 29.4702 -0.676119 14.2 -7.80782 -5937 6 27.8751 27.8625 12.1001 -31.3933 22.4686 19.454 -5938 4 27.5095 28.719 12.4446 7.36494 -19.3603 -4.77408 -5939 4 28.6439 28.079 11.5991 25.5597 3.40516 -15.3306 -5940 6 23.5464 30.4867 38.1533 -1.61625 -6.62341 9.61758 -5941 4 24.0833 30.8354 38.8715 -5.37174 -4.61911 9.80189 -5942 4 23.9933 30.8636 37.4157 3.53805 3.96797 -22.0348 -5943 6 48.0805 24.2983 17.323 -13.282 16.609 -1.2587 -5944 4 47.4189 24.8263 17.8481 20.4082 -10.1323 -14.146 -5945 4 48.1392 24.7467 16.448 -1.93384 -6.90404 13.1726 -5946 6 38.5137 5.30503 40.3397 -7.95418 19.3032 15.6478 -5947 4 38.8605 4.51762 39.8919 14.9068 5.60332 0.485922 -5948 4 39.0782 6.12858 40.3573 -2.94219 -25.5867 -8.28862 -5949 6 31.2334 3.92786 33.7298 9.31662 9.08835 -13.8199 -5950 4 31.8178 4.24357 33.0198 -6.00608 1.6224 5.38661 -5951 4 31.5957 3.05883 33.9262 -1.57661 -10.2527 7.73336 -5952 6 41.2417 8.81323 38.1247 -0.484904 -12.0607 11.4744 -5953 4 40.9476 8.42023 38.9721 -0.376638 9.54125 -7.13918 -5954 4 41.2604 9.77162 38.2616 1.58028 -2.03482 4.89657 -5955 6 53.3602 29.1001 24.587 -11.0956 7.72569 2.80506 -5956 4 52.5731 28.5594 24.8544 13.5868 20.3826 -7.54714 -5957 4 53.0545 29.9696 24.221 1.09296 -21.6534 7.27768 -5958 6 54.9204 15.5334 40.7094 -9.73888 -15.8123 9.62316 -5959 4 54.8689 16.4143 40.4003 18.499 35.235 -15.9181 -5960 4 53.9936 15.418 40.9228 -4.36807 -19.1537 6.40504 -5961 6 46.4046 17.0769 31.8825 -4.88415 8.61979 -0.317809 -5962 4 46.5643 17.9902 31.5503 -4.54791 -14.0743 0.407713 -5963 4 45.6863 16.6828 31.3336 12.87 12.2001 8.08584 -5964 6 36.9136 25.0502 23.0508 4.56287 5.14957 -21.3849 -5965 4 37.1181 25.0639 23.9643 8.53293 7.7605 31.6671 -5966 4 36.2092 24.4176 22.9617 -10.0712 -5.98832 -5.36051 -5967 6 11.3786 4.43396 15.9309 9.37238 17.2608 -3.05203 -5968 4 11.3458 3.5794 15.4688 2.43716 9.1998 0.97888 -5969 4 11.7026 5.12247 15.2999 -5.70859 -16.4138 5.77914 -5970 6 12.7896 7.06818 19.4525 -2.66824 36.6483 10.7184 -5971 4 12.9865 6.29411 18.9417 0.495259 -24.323 -4.17525 -5972 4 12.2519 6.828 20.2299 7.04203 -8.59773 -13.3487 -5973 6 12.0617 33.6499 17.5439 8.15138 -13.8576 -23.5514 -5974 4 11.882 34.0654 18.3682 -11.1792 16.7137 24.4072 -5975 4 12.5902 32.8825 17.8108 -1.08307 -0.300652 -3.52071 -5976 6 10.2421 4.75805 2.56564 19.3085 -11.8452 1.86691 -5977 4 9.45693 4.42703 2.99801 -10.4664 -1.42643 2.59081 -5978 4 10.9264 4.04527 2.68225 -6.18235 16.1727 -3.70264 -5979 6 4.57251 36.8735 12.1563 3.74049 -23.6741 -21.1206 -5980 4 4.47996 37.7154 12.5491 -11.9533 34.2042 20.255 -5981 4 5.43811 36.9355 11.7449 0.921031 -10.3689 -0.351167 -5982 6 30.7412 35.3317 25.8213 -33.1423 -23.543 6.44877 -5983 4 31.2776 35.279 26.6136 10.5944 3.70967 -1.00248 -5984 4 29.9668 34.7615 26.0677 13.1622 11.7399 -12.7178 -5985 6 20.1808 7.16217 1.863 30.1084 16.4868 -11.867 -5986 4 20.9002 6.54767 2.16414 -16.0511 17.5979 -8.58506 -5987 4 20.6676 7.94845 1.45686 -14.4541 -29.1822 13.3394 -5988 6 21.7608 6.89709 28.9964 -11.5861 -1.80466 -8.03013 -5989 4 22.036 7.16072 29.8728 6.26891 1.69864 13.9065 -5990 4 22.5393 6.5849 28.5353 8.83449 0.101288 -1.59126 -5991 6 6.87368 37.1369 6.9386 0.0966708 26.3677 27.0276 -5992 4 7.29364 38.0249 6.81033 -7.58004 -19.2864 -7.26696 -5993 4 6.61926 37.1727 7.88431 1.83825 -7.02501 -19.6681 -5994 6 37.1919 18.383 16.2937 29.0289 34.5069 -53.2335 -5995 4 36.6258 18.6038 17.011 -19.1901 14.6481 22.2869 -5996 4 37.3395 19.2625 15.7718 -11.4936 -34.1346 27.3139 -5997 6 52.3871 25.4845 31.3088 43.0013 26.9533 24.6388 -5998 4 52.3889 26.4071 31.692 -12.9868 -26.5619 -15.078 -5999 4 53.3562 25.2868 31.368 -25.5563 -9.18093 -7.26498 -6000 6 3.9438 39.8542 16.3866 5.1752 -27.5036 1.27902 -6001 4 3.12325 39.6837 16.8533 -2.95342 6.97088 0.658243 -6002 4 4.2268 38.9387 16.1321 1.7457 31.291 -0.663648 -6003 6 26.0576 14.6358 18.3044 5.96149 26.4073 -5.45028 -6004 4 27.0205 14.6227 18.4365 -6.17521 2.0803 0.6884 -6005 4 25.8163 15.5963 18.2277 1.60591 -22.5499 1.70317 -6006 6 22.193 39.6312 23.63 -9.05536 -28.9999 9.83005 -6007 4 22.6639 40.3889 23.3083 10.2118 22.7493 1.36107 -6008 4 21.7625 39.8434 24.4837 8.53947 8.47814 -10.8223 -6009 6 5.99591 12.8758 22.3742 5.3436 -0.661706 -0.190442 -6010 4 6.14325 13.1833 21.4713 -0.679137 1.38292 -0.893953 -6011 4 6.87425 12.6139 22.6767 3.78948 -2.07704 1.05968 -6012 6 48.9338 28.1628 34.7078 -35.8712 26.2385 4.15493 -6013 4 48.201 27.5556 34.4701 19.6025 -0.265843 1.21851 -6014 4 49.8217 27.8183 34.7001 12.2446 -20.4038 -3.75147 -6015 6 7.76997 22.4407 33.2353 -5.03116 -11.9457 7.57841 -6016 4 8.01899 22.0009 34.0594 5.33952 7.11928 -2.86974 -6017 4 7.10669 21.8538 32.8613 -1.17853 4.26119 -2.40878 -6018 6 41.0955 39.6222 11.7091 10.6381 -27.5326 3.52715 -6019 4 40.5189 40.2602 11.288 0.0449404 21.7474 -0.525631 -6020 4 41.8612 39.9918 12.1934 -14.1016 15.1893 -9.59654 -6021 6 26.8828 37.915 39.359 -2.28209 0.567193 11.8658 -6022 4 27.0774 38.1179 40.3058 -8.7685 -4.90824 -13.677 -6023 4 25.9807 37.5277 39.3071 12.6176 5.79057 5.20946 -6024 6 16.8333 41.5427 16.7885 -17.5694 -7.84814 -1.75502 -6025 4 17.5277 0.148354 16.3589 5.69783 -2.62712 11.3029 -6026 4 16.9979 41.3393 17.726 8.37907 5.88226 -10.2657 -6027 6 19.018 8.99657 17.6669 -0.857073 -13.2853 32.8939 -6028 4 18.786 9.90902 17.9004 1.19423 -0.949069 -3.8378 -6029 4 19.1413 8.47286 18.5173 -2.13518 15.132 -32.6231 -6030 6 31.1034 24.3848 20.0884 -4.53251 11.7336 -2.81937 -6031 4 30.5766 24.6463 20.8643 6.13742 -4.20791 -6.36966 -6032 4 31.7352 25.0989 19.9557 0.422515 0.146513 0.562515 -6033 6 24.595 6.30881 27.6069 -9.90555 -11.0232 -14.6341 -6034 4 24.6965 6.6392 26.7007 0.89989 8.76246 8.56835 -6035 4 24.5083 5.35606 27.4824 0.344086 -1.65377 9.53776 -6036 6 11.6335 5.32908 8.21523 29.3959 14.5761 -12.3078 -6037 4 10.744 5.12885 8.4339 -32.4949 -9.42488 11.9016 -6038 4 11.5648 6.10082 7.62627 0.276207 -9.77668 5.48929 -6039 6 16.478 34.2375 17.2464 48.0037 -1.61779 7.84119 -6040 4 15.7306 34.6529 16.8034 2.48832 11.605 -8.49411 -6041 4 17.405 34.6677 17.061 -56.7063 -17.2336 2.19282 -6042 6 40.7477 40.4696 8.51561 8.11488 -8.65224 -15.2287 -6043 4 40.0224 40.6832 9.09702 -8.50867 2.70994 6.70857 -6044 4 40.4514 39.6579 8.0617 2.3787 8.8385 5.97324 -6045 6 42.7444 5.87231 14.2984 24.2128 7.61876 -1.56509 -6046 4 42.0757 5.96647 14.9632 -14.4615 -1.80987 8.42029 -6047 4 42.482 5.17586 13.6922 -11.2697 -3.69634 -0.0191913 -6048 6 14.3614 21.0573 6.06698 -40.3301 2.02826 20.3099 -6049 4 14.5082 21.6099 6.85229 1.25225 -5.13952 -5.68983 -6050 4 15.1941 20.9025 5.67555 35.2665 -1.55979 -15.977 -6051 6 16.3015 37.7733 18.121 -25.7671 9.10936 -15.4408 -6052 4 15.381 38.1761 18.2458 41.2545 -15.1679 7.93486 -6053 4 16.7788 37.6858 18.9587 -11.1023 5.71932 1.62274 -6054 6 40.7984 27.7161 27.1129 -11.0179 0.499807 -0.336913 -6055 4 41.4742 27.2927 27.66 5.56711 1.79851 -1.75817 -6056 4 41.2133 28.334 26.4954 6.67104 -1.0644 4.19578 -6057 6 44.9561 25.991 14.0487 25.7727 -16.7938 -19.0088 -6058 4 45.3739 25.1637 13.7108 -16.5098 12.8855 15.8726 -6059 4 45.5476 26.6442 13.6478 -7.0093 2.51014 3.36733 -6060 6 2.61494 33.9473 21.2474 -9.6198 2.06317 -4.83635 -6061 4 2.13704 34.7904 21.3802 4.44423 -7.12162 -0.559399 -6062 4 2.10703 33.4352 20.5879 2.52794 8.8644 7.26413 -6063 6 5.77575 4.45209 12.8318 1.03208 18.7287 8.08797 -6064 4 5.35339 3.69685 13.2518 -3.06112 -10.1665 -2.69945 -6065 4 5.8052 5.15326 13.507 0.887863 -7.02627 -5.52828 -6066 6 16.8649 5.92112 7.40874 19.9951 -5.29142 4.66315 -6067 4 16.4994 5.07825 7.12483 -4.58221 -9.71617 -5.56506 -6068 4 16.109 6.48147 7.52662 -16.4719 8.95214 3.19539 -6069 6 17.8298 38.4233 36.8534 9.258 40.3096 -0.310058 -6070 4 17.7926 39.4131 36.8935 -6.04129 -19.7424 1.84578 -6071 4 18.5177 38.2893 36.201 1.93535 -10.8086 -1.92368 -6072 6 43.3019 20.5959 5.44166 -6.9278 5.85438 -3.52603 -6073 4 43.1055 21.501 5.07158 -2.97833 -26.833 8.04502 -6074 4 42.4661 20.0651 5.41852 11.3272 16.2867 -2.99003 -6075 6 21.5372 23.2991 30.4448 -14.935 11.2275 -26.3705 -6076 4 20.9947 23.0537 31.1809 -7.12546 -6.28648 20.8256 -6077 4 20.8648 23.582 29.7655 22.6032 -4.28693 10.3415 -6078 6 0.251317 28.0486 36.1651 -22.0243 21.0356 -19.5016 -6079 4 1.02049 27.7114 36.6113 18.9729 -1.47718 6.47801 -6080 4 0.506474 28.8456 35.6445 2.58205 -12.8812 9.00708 -6081 6 3.04678 17.0589 11.5707 1.23946 -7.00965 -18.5436 -6082 4 3.14519 17.2619 12.4977 -1.89892 8.1653 13.6088 -6083 4 2.54959 17.7766 11.1613 1.73961 1.36316 5.23635 -6084 6 24.1645 37.0333 23.9496 -13.0802 10.7124 17.6799 -6085 4 23.6099 37.8384 23.8849 6.1763 -9.33563 -1.28122 -6086 4 24.4663 37.0147 24.8893 -3.58635 -1.49958 -18.3056 -6087 6 3.94341 20.5209 27.4789 6.12038 36.4957 26.1587 -6088 4 3.64002 20.0757 26.7101 -13.0247 -10.3927 -30.3524 -6089 4 3.8213 21.4921 27.3096 0.6263 -21.942 -1.90407 -6090 6 54.8381 2.78983 29.6272 25.3782 12.002 29.7256 -6091 4 54.8259 2.49183 30.5832 -3.08894 8.50949 -25.0172 -6092 4 0.681738 3.33643 29.5869 -23.0163 -14.7319 0.890579 -6093 6 27.1738 8.43221 31.7209 4.37325 44.8318 10.1666 -6094 4 26.7765 8.21235 30.8513 3.34031 12.9925 0.247925 -6095 4 27.4394 9.43578 31.8184 -18.7706 -51.1708 -12.8964 -6096 6 30.9422 1.62815 30.3909 7.68258 9.19266 14.5116 -6097 4 30.6848 0.902997 29.8247 -17.6873 -14.6962 -9.63211 -6098 4 30.1385 1.96768 30.8202 -2.70664 -9.08975 -4.26502 -6099 6 26.4126 36.4396 36.8407 14.7094 2.78685 2.16538 -6100 4 26.1754 35.936 36.0621 -1.37556 -1.6634 -9.1832 -6101 4 27.3614 36.6667 36.7609 -11.9856 -2.56278 0.470716 -6102 6 51.3051 10.055 21.7064 16.9271 -12.7171 -0.47742 -6103 4 50.71 9.38094 22.0984 13.3581 11.7028 -6.50503 -6104 4 52.1297 9.58932 21.3894 -28.6693 12.5934 9.83408 -6105 6 52.4269 12.3712 23.2743 -6.4707 23.0639 13.1163 -6106 4 51.7645 13.1043 23.2119 13.6159 -11.3613 1.42096 -6107 4 52.024 11.6223 22.842 -6.69009 -13.0182 -9.76131 -6108 6 10.0084 38.37 20.6075 21.9453 -2.41338 -4.30271 -6109 4 9.45069 38.2813 21.3825 -6.19229 -0.201962 6.85596 -6110 4 10.9137 38.1225 20.8794 -8.5598 0.614521 -3.9406 -6111 6 22.7031 33.2664 0.640708 10.9794 6.62646 4.85135 -6112 4 23.6679 33.2996 0.582378 1.56947 7.5672 2.73741 -6113 4 22.5144 32.4288 0.230474 -14.5468 -15.5809 -6.04383 -6114 6 14.0917 40.8812 25.4864 9.18744 8.89463 -14.7226 -6115 4 14.196 40.6884 26.4283 -5.63746 -5.20078 0.271339 -6116 4 13.2439 40.5125 25.1796 5.27736 1.6069 9.18822 -6117 6 42.7681 15.0783 14.9763 7.15748 5.71054 -2.59845 -6118 4 43.0785 15.7158 14.2901 -5.10451 -16.9901 16.8665 -6119 4 41.8327 15.2592 15.1092 -5.54173 -0.124331 1.80857 -6120 6 30.2406 7.22111 8.53832 -0.545825 26.9265 -4.64375 -6121 4 30.1758 8.19473 8.52708 -1.1145 -9.52086 -16.9196 -6122 4 30.4024 7.07989 9.45321 5.06633 -17.0605 24.2519 -6123 6 3.37759 19.8423 41.3077 23.4194 0.89426 -0.123069 -6124 4 3.19865 19.3681 40.4829 0.842743 3.23829 1.04749 -6125 4 4.34953 20.0012 41.2688 -20.407 -4.57585 2.1738 -6126 6 8.87423 25.1354 17.2017 -10.0567 -4.23249 -18.7298 -6127 4 8.96932 24.947 16.2256 5.94886 2.92938 28.6011 -6128 4 9.65182 24.8278 17.6915 0.0257745 -5.63434 -9.64419 -6129 6 9.32494 14.9555 22.0283 -12.5325 4.5599 7.62514 -6130 4 9.01993 14.8718 22.9489 -0.27625 1.365 -7.1979 -6131 4 10.1958 14.5523 22.0148 2.38734 -2.44115 -2.54227 -6132 6 2.03086 4.7751 20.8592 -0.302533 -25.5342 -8.8148 -6133 4 2.76807 5.37577 20.9697 7.90436 11.3601 5.00545 -6134 4 1.2576 5.15949 21.2703 -7.54078 11.376 6.7073 -6135 6 18.2964 7.06718 3.86051 -0.633466 1.54328 39.8902 -6136 4 18.916 7.22135 3.16498 20.2468 5.35447 -22.1173 -6137 4 18.8081 6.54637 4.52758 -12.8964 10.087 -8.61721 -6138 6 17.0178 19.1734 19.8425 8.05121 8.342 4.19715 -6139 4 17.786 18.9037 19.3194 -9.06534 -4.96345 -2.22737 -6140 4 16.269 18.585 19.6427 11.1227 0.819232 -3.01639 -6141 6 4.30363 6.55267 21.3463 7.67654 -0.43578 -3.38259 -6142 4 4.33009 7.06923 20.5107 4.36212 -5.74714 10.2686 -6143 4 5.22777 6.26626 21.5669 -20.6993 9.2157 -12.5452 -6144 6 20.7848 36.9284 35.662 4.03453 1.95325 3.7669 -6145 4 20.2254 37.0836 34.8976 -2.25577 1.87165 -3.27163 -6146 4 20.2383 36.4327 36.2875 0.848364 -0.11832 4.44878 -6147 6 4.7306 15.0205 31.2333 -1.91968 -20.8619 8.65585 -6148 4 4.4229 14.7734 32.1398 6.18773 10.2906 -17.1472 -6149 4 4.73385 15.973 31.1263 -2.35963 8.87481 4.31723 -6150 6 2.35358 1.22877 17.5767 10.9459 -8.92502 -6.22121 -6151 4 3.05741 1.28614 16.8672 -19.772 5.07478 19.7417 -6152 4 1.94409 2.09607 17.7592 7.86728 -5.07336 -5.26938 -6153 6 34.6221 31.5613 19.8029 0.0167231 -1.91103 -0.857839 -6154 4 35.0026 31.8698 18.9629 1.12657 -3.13716 4.28436 -6155 4 34.4223 32.3623 20.3103 -0.485441 0.265221 -3.01806 -6156 6 24.1912 21.6103 13.5173 31.6251 8.72647 13.7111 -6157 4 25.0921 21.8731 13.8418 -25.6554 -7.43575 -12.369 -6158 4 23.5893 22.1875 13.984 -2.65104 7.77201 2.87587 -6159 6 37.2187 41.0834 5.69361 1.76676 -13.0415 -0.936073 -6160 4 37.8761 41.7354 5.91144 16.7665 3.57334 0.125879 -6161 4 36.4089 41.5349 5.88363 -19.4064 5.82624 -1.33385 -6162 6 8.4323 8.00063 20.2395 28.2224 -17.334 -6.20124 -6163 4 9.29892 8.115 20.6547 2.73811 -3.60152 -0.447724 -6164 4 7.94828 8.69862 20.6224 -29.3938 29.4062 12.6481 -6165 6 14.9357 18.8843 36.7618 11.8158 33.7978 0.271425 -6166 4 14.1259 19.2123 36.362 -3.40669 -6.42507 -0.135577 -6167 4 15.5651 19.6361 36.6422 -7.52364 -17.7077 5.06346 -6168 6 43.9725 40.6444 18.6569 4.16672 -2.33153 16.0012 -6169 4 43.9166 40.834 17.7203 0.682613 4.51617 -13.4207 -6170 4 44.9212 40.6761 18.9032 -12.0211 -3.47257 -3.21486 -6171 6 33.7852 32.2494 37.3449 -11.8504 2.76306 -14.1758 -6172 4 34.0177 32.2775 36.4055 -1.41242 -0.232407 11.1732 -6173 4 34.3686 31.6236 37.7745 10.7747 -2.06792 3.13276 -6174 6 5.09749 29.2901 24.0356 16.7213 -6.5526 19.7529 -6175 4 5.77222 29.487 24.7328 -11.5239 -2.29901 -14.2657 -6176 4 4.7684 30.1321 23.7215 -1.73734 11.0072 -2.10513 -6177 6 33.6153 36.4198 10.9805 1.47517 3.52666 5.33615 -6178 4 32.7579 36.4403 10.5596 -3.06779 3.10292 -7.60642 -6179 4 33.384 36.4828 11.91 5.71512 -0.747971 7.16991 -6180 6 28.3006 33.5952 13.1115 6.62888 -15.4249 13.7129 -6181 4 27.948 33.7778 12.2398 -4.56551 -8.24283 -4.77521 -6182 4 28.1705 32.6462 13.2914 -0.364449 12.3294 -7.26248 -6183 6 6.16378 19.058 24.2919 3.99573 -9.29146 -27.7059 -6184 4 6.01812 19.825 24.8144 -3.49512 27.1397 16.8881 -6185 4 6.29927 18.3335 24.8859 3.7649 -20.2974 16.0908 -6186 6 28.4267 19.9356 1.8581 6.30761 1.98196 1.30153 -6187 4 28.5945 19.3745 1.10227 -2.74725 -9.675 -9.29711 -6188 4 29.2893 20.1184 2.23075 1.76934 5.71608 2.57016 -6189 6 42.0557 23.969 9.55925 -0.174378 -1.97525 4.49576 -6190 4 42.3037 23.8044 10.4694 5.92504 9.79373 11.5418 -6191 4 41.7282 23.1152 9.29053 -8.19873 -12.6145 -11.7634 -6192 6 43.5187 7.30226 27.4319 7.08124 -12.3985 0.368771 -6193 4 42.7424 7.14751 27.9838 -5.23639 1.01312 3.8871 -6194 4 43.2552 7.97753 26.8025 -4.71413 8.37143 -8.21745 -6195 6 20.4824 33.0041 9.27291 -32.573 -27.3267 34.6611 -6196 4 19.7824 32.5876 9.93875 35.2414 32.5831 -36.6535 -6197 4 20.3431 33.9616 9.1663 -10.2228 -2.75758 9.24016 -6198 6 38.0326 35.2526 15.9362 -7.94884 -19.6622 -5.99631 -6199 4 37.3459 34.9971 15.2894 4.63074 2.95951 5.93375 -6200 4 37.9463 34.6017 16.6504 2.45283 5.99568 -2.76115 -6201 6 47.5301 20.8853 3.96175 -5.34824 -5.66637 20.3565 -6202 4 47.9759 21.3648 3.2498 -4.9297 7.97101 8.48596 -6203 4 47.5029 21.3928 4.81786 6.75175 -1.3172 -26.6206 -6204 6 10.9933 31.6966 41.4271 11.47 5.02521 -0.853614 -6205 4 11.6392 31.7665 40.7132 0.112137 -5.28149 3.10577 -6206 4 10.1353 31.6993 40.998 -8.62143 -0.203152 -1.66696 -6207 6 43.2403 12.6562 2.57215 9.62694 -8.68348 -18.5989 -6208 4 42.9077 12.993 3.39384 -2.38679 2.43178 19.528 -6209 4 44.033 12.1261 2.78242 -8.9232 8.2725 3.71991 -6210 6 49.4204 25.4105 21.1683 5.59269 -12.2048 -2.72561 -6211 4 50.0196 25.2987 20.4097 -7.64964 4.29225 2.01473 -6212 4 48.8877 24.5919 21.195 1.69169 7.44836 1.02425 -6213 6 1.95674 34.1403 26.4747 8.8762 -24.2704 6.47661 -6214 4 2.77674 33.6103 26.5537 -12.4269 14.6955 -4.62849 -6215 4 1.26657 33.4613 26.3994 -1.21739 9.31774 -1.03397 -6216 6 17.1306 20.8229 36.6851 -31.9931 14.1441 13.8122 -6217 4 16.9533 21.7471 36.9985 5.62896 -19.6931 -5.93312 -6218 4 18.0634 20.696 36.5868 23.783 -2.64609 -3.70934 -6219 6 36.6048 10.9866 3.71548 -5.44552 8.31799 24.2539 -6220 4 35.7423 11.3886 3.87785 -5.6936 5.55042 -13.8219 -6221 4 36.8135 10.7077 4.61447 10.9535 -7.59336 -0.361553 -6222 6 14.2169 20.6838 21.9439 11.6961 23.12 -6.3106 -6223 4 13.8085 20.2376 21.1912 1.98746 8.13024 -7.83415 -6224 4 14.8103 21.4259 21.6461 -14.674 -27.097 -1.82439 -6225 6 33.9151 12.2544 9.54899 39.8857 -26.0408 -21.0892 -6226 4 34.3088 11.5163 10.0208 11.0461 -3.70138 -11.6499 -6227 4 33.2997 12.4814 10.1903 -47.9458 31.9244 32.2008 -6228 6 21.8056 41.4836 2.15686 0.64336 -1.87746 -8.80618 -6229 4 22.0354 41.6672 1.22189 -5.57638 1.91412 12.8342 -6230 4 22.5122 40.9391 2.50884 5.16687 -0.375256 0.644554 -6231 6 20.9282 10.4547 14.1996 25.019 -0.0729632 25.5582 -6232 4 21.5922 10.842 14.8375 -21.0894 -6.80718 -21.5316 -6233 4 20.826 9.54084 14.5456 -0.887825 12.9084 -9.51249 -6234 6 6.24616 4.45231 24.6293 -10.9468 0.993291 2.39826 -6235 4 6.83688 4.17894 23.9311 12.242 -0.137787 -14.9911 -6236 4 5.68087 3.68408 24.7586 -3.59028 -1.51582 -1.5433 -6237 6 50.784 14.5954 23.4824 21.8736 9.84292 5.60122 -6238 4 51.2681 15.1205 24.1582 -9.03857 -7.6656 -10.4761 -6239 4 49.9341 14.3608 23.8519 -7.60536 -4.54693 6.65168 -6240 6 52.7678 13.9144 9.68214 -3.90955 36.1598 -0.40974 -6241 4 52.8738 13.0144 9.92216 4.47335 -34.5538 7.53363 -6242 4 51.8729 14.0092 9.35938 -14.036 0.105332 -6.17221 -6243 6 9.05048 2.05234 29.9152 -29.3842 -12.1538 -14.6176 -6244 4 9.42756 2.83336 30.2687 13.3628 24.1087 13.7335 -6245 4 8.09173 2.26823 29.8032 18.9866 -6.39081 0.174186 -6246 6 7.13499 29.9757 26.2377 7.52656 -33.046 2.78556 -6247 4 6.52748 30.39 26.8607 -0.20976 -1.88395 4.87081 -6248 4 7.49713 29.1538 26.6869 -11.4544 24.9502 -11.4644 -6249 6 49.1541 41.742 14.3355 11.4439 21.5488 -10.6063 -6250 4 49.5333 41.2573 13.5835 -2.72613 -5.13007 3.47372 -6251 4 49.526 0.750494 14.2401 -8.50163 -23.9907 2.80869 -6252 6 5.64545 3.82333 19.1929 -5.43924 -10.1162 19.2647 -6253 4 5.12472 3.39384 19.906 6.51959 7.46947 -11.8792 -6254 4 5.07872 3.8651 18.4273 -3.31865 2.78603 -7.74707 -6255 6 9.32747 35.8381 24.9081 -3.67476 7.0144 6.61099 -6256 4 10.2167 35.7622 24.5243 -1.5306 1.39279 3.84516 -6257 4 9.42305 36.4736 25.6393 1.10498 -0.920313 -3.33942 -6258 6 53.0258 29.7567 11.5493 -1.29773 -2.97991 8.71205 -6259 4 53.4398 30.4104 10.9769 2.6525 4.63524 -3.89524 -6260 4 52.8324 30.2122 12.386 1.27544 -1.91261 -4.55584 -6261 6 22.6082 9.97702 5.69106 1.45951 -2.04334 43.7981 -6262 4 23.4598 10.2484 6.09617 -7.85329 -3.83944 -13.5574 -6263 4 22.5497 10.2693 4.79236 2.60512 5.60546 -21.7219 -6264 6 39.5532 19.6216 2.68726 -3.50035 -14.5445 -22.3968 -6265 4 38.6563 19.3067 2.54039 -1.65167 0.121811 17.9309 -6266 4 39.9003 19.405 1.80953 18.3116 7.78412 6.67062 -6267 6 45.082 35.5833 7.81025 20.3465 -2.3491 -25.2688 -6268 4 45.1219 36.3229 8.40611 -5.73741 11.9797 15.8104 -6269 4 44.452 34.9332 8.12016 -12.4923 -3.86067 9.83054 -6270 6 29.7976 14.244 9.96067 -5.32248 -4.64296 1.12628 -6271 4 30.0443 14.0971 9.02808 -4.18819 -1.64606 2.67632 -6272 4 28.8444 14.0269 10.0606 18.5465 4.64021 -4.02524 -6273 6 29.2523 30.155 21.8932 -5.77992 6.30922 3.94049 -6274 4 29.1431 30.8143 21.21 -7.42967 10.4849 -3.0507 -6275 4 30.0153 29.6632 21.6201 11.6336 -14.2167 -2.13367 -6276 6 11.1107 18.8213 6.56056 -14.6836 -1.88929 0.635516 -6277 4 11.166 19.7501 6.27543 7.98891 -2.6539 -0.194038 -6278 4 11.9915 18.4225 6.59495 6.41359 9.14832 -2.51569 -6279 6 13.4142 39.1371 13.4638 17.7807 -10.3765 -23.6259 -6280 4 13.7831 39.7975 14.0449 5.16656 9.87024 9.85065 -6281 4 12.6066 38.8468 13.8734 -16.0883 -5.26763 6.93978 -6282 6 50.1521 12.9948 0.13749 23.7903 11.3983 42.7862 -6283 4 49.8531 12.6437 41.2486 -17.3674 -16.2897 -43.7514 -6284 4 50.6811 12.2823 0.528204 -2.61001 5.26075 1.59628 -6285 6 47.8279 31.3538 27.7873 0.535952 -14.579 -21.2406 -6286 4 47.8981 31.8966 28.5732 -11.876 9.28639 5.42067 -6287 4 46.9879 31.5201 27.3031 12.1261 3.81279 14.9113 -6288 6 27.708 1.63283 7.49454 14.1634 -3.44528 -21.3886 -6289 4 26.9442 1.71926 8.04828 -16.4795 3.87106 10.0363 -6290 4 27.4331 1.03137 6.77318 -2.44435 3.14912 6.58235 -6291 6 54.8843 20.7912 16.041 -0.591057 -23.5277 -19.4313 -6292 4 54.9506 20.9946 16.9763 2.49267 -3.51754 11.2958 -6293 4 0.215527 19.8591 15.8725 -6.64294 24.8159 10.1677 -6294 6 37.4309 32.9919 34.4461 -3.01999 17.5498 0.613574 -6295 4 37.2599 32.074 34.6492 -8.98721 -14.1314 1.69718 -6296 4 36.602 33.3843 34.0789 10.8556 -9.90957 7.57788 -6297 6 19.516 39.775 6.74949 1.2991 -23.719 -0.568837 -6298 4 19.1628 39.2461 5.9771 11.6696 10.1577 21.4746 -6299 4 19.8715 39.1258 7.41882 -10.6166 14.587 -19.1486 -6300 6 32.439 2.74298 8.0597 2.15016 14.1028 28.0311 -6301 4 32.8474 3.04427 8.91221 -2.20578 -4.83758 -21.9226 -6302 4 31.6043 2.37221 8.38063 -2.27075 -4.50389 -9.9889 -6303 6 12.9757 16.0783 4.05517 0.782156 -17.4841 -11.0101 -6304 4 12.5393 15.6612 4.81952 2.97976 0.136191 -5.67644 -6305 4 13.3707 15.3387 3.55371 -3.64889 7.0956 8.52646 -6306 6 4.65115 29.9533 5.41887 4.80886 14.2508 -32.4371 -6307 4 5.0407 30.2031 4.52094 -17.5959 -12.1853 28.663 -6308 4 3.95879 29.263 5.26663 23.43 17.9812 0.878069 -6309 6 29.754 32.1152 24.0535 7.2798 7.01713 3.37681 -6310 4 30.6602 32.1649 24.4187 -11.1956 -0.828668 -6.39664 -6311 4 29.7572 31.4388 23.3746 -2.03067 -7.97912 -3.55015 -6312 6 11.8649 30.6972 33.4692 4.66278 -43.8766 26.3819 -6313 4 11.8723 29.8544 34.0435 -6.78391 38.5593 -23.2698 -6314 4 12.7601 30.7129 33.1118 -0.162199 2.5806 0.32685 -6315 6 17.3589 40.4121 27.3072 22.6925 26.1242 -9.80885 -6316 4 17.3318 41.3765 27.4299 10.8839 -2.3351 -5.50809 -6317 4 16.5554 40.1462 27.6883 -41.5002 -17.3681 16.6281 -6318 6 8.67113 4.89706 8.92484 12.0335 -9.87957 -4.1983 -6319 4 8.33733 5.39218 8.1724 -5.0195 2.6367 -1.72337 -6320 4 8.22391 5.22927 9.70847 -2.49168 4.71619 2.25155 -6321 6 39.5722 17.6819 9.57834 18.7012 -23.4437 -36.958 -6322 4 39.2207 17.6668 10.4653 -7.32211 -9.11094 11.7967 -6323 4 39.6226 16.7555 9.16114 -8.90732 35.1542 21.3272 -6324 6 31.4906 30.1663 28.5669 -18.2413 -3.40307 10.1233 -6325 4 32.2933 30.4252 28.099 2.93126 -8.695 5.25695 -6326 4 31.6493 29.3506 29.0723 8.50077 6.58979 -7.17605 -6327 6 52.667 19.2904 40.0609 -3.10376 4.72625 -3.48654 -6328 4 52.9542 18.5867 39.4362 -2.88314 13.2503 8.01058 -6329 4 53.0181 20.1618 39.7754 -0.243354 -8.89628 -7.05583 -6330 6 3.24103 7.80987 9.85575 15.4795 13.9798 -0.387217 -6331 4 3.75934 8.59525 10.1836 -13.0283 -21.6848 -11.3123 -6332 4 3.84189 7.30622 9.27659 -5.58147 6.91981 6.81825 -6333 6 23.1336 35.2172 35.587 -21.8844 -14.3383 30.559 -6334 4 23.8289 35.3646 34.9695 18.2116 12.6911 -23.5817 -6335 4 22.438 35.8962 35.5045 5.76256 0.966742 -5.52301 -6336 6 19.4997 14.0668 20.8253 -20.4482 -5.33672 -12.8711 -6337 4 19.9465 14.5101 21.5526 -0.10572 6.16799 9.82761 -6338 4 18.517 14.0876 20.9737 19.1914 1.01522 3.6393 -6339 6 23.6166 15.8675 24.0247 18.6101 -11.8924 -11.0295 -6340 4 23.7056 16.8159 24.0204 -5.88143 19.7526 4.0278 -6341 4 24.4592 15.5679 23.6279 -14.5441 0.474754 5.50536 -6342 6 0.271665 30.4941 6.10208 19.3679 10.4089 38.3983 -6343 4 55.0639 30.1609 5.24948 -13.9023 -9.5098 -30.2095 -6344 4 54.47 30.83 6.54681 -8.02886 -2.57547 -7.81581 -6345 6 4.88814 13.205 29.1223 -11.8587 -43.2127 -22.2411 -6346 4 4.78002 13.8458 29.7909 -3.08187 32.2273 31.1649 -6347 4 5.63816 13.4614 28.593 12.4558 6.3486 -8.85318 -6348 6 54.2078 27.2696 19.1963 -15.9712 -23.151 25.2067 -6349 4 0.0774591 27.3551 19.591 11.6552 0.895327 2.86932 -6350 4 54.2345 27.7605 18.3958 2.66703 17.7524 -27.3595 -6351 6 13.918 35.7451 9.18145 -1.78919 -38.7722 -17.1362 -6352 4 13.6805 34.9997 8.54227 8.11159 28.2534 18.027 -6353 4 13.9675 36.5302 8.63631 -0.993585 8.08981 -9.4946 -6354 6 5.91273 31.9181 18.8024 -12.4461 1.37758 17.74 -6355 4 5.51416 32.8097 18.9023 4.86685 -6.68339 -12.1033 -6356 4 6.30341 31.7597 17.9414 -1.0189 10.0948 -10.5031 -6357 6 5.79665 28.8753 9.48388 1.22923 1.68801 -9.18455 -6358 4 5.13151 29.3325 10.0083 -4.81051 1.68465 1.48607 -6359 4 5.29369 28.2634 8.9143 2.26517 5.17431 2.85494 -6360 6 40.1173 6.05944 9.72118 13.8961 -11.6659 -14.1698 -6361 4 40.0092 6.65032 8.94634 5.33155 -13.6 11.5113 -6362 4 40.8322 5.39707 9.49335 -23.1878 23.6737 0.508505 -6363 6 20.33 13.449 41.3936 11.1096 -0.534149 -19.18 -6364 4 21.2311 13.7006 41.7531 -26.0398 -5.61362 -19.048 -6365 4 20.2547 13.6822 40.4168 8.50391 -3.95591 26.8537 -6366 6 14.4455 21.736 27.3642 10.1345 -2.11962 18.0607 -6367 4 15.3888 21.7922 27.5976 -10.3958 0.0660495 -7.924 -6368 4 14.3649 21.6255 26.4124 4.42937 0.724974 -0.20238 -6369 6 38.7561 1.79551 30.0553 7.9914 -17.3849 -15.575 -6370 4 38.4573 2.01955 30.9195 -8.42419 6.13431 27.6354 -6371 4 38.9299 2.64677 29.6557 3.10695 8.29419 -8.65227 -6372 6 5.60526 10.8558 14.1801 -12.7318 -17.5226 5.68918 -6373 4 4.9397 11.5438 14.0518 -0.153792 0.369728 -2.18729 -6374 4 5.10481 10.0791 14.5379 11.5553 16.0131 -9.09073 -6375 6 45.3957 36.7129 27.9145 12.4213 23.5208 -28.0365 -6376 4 46.0624 36.7782 28.6036 -4.12954 -6.22049 8.27184 -6377 4 45.8092 37.2197 27.1638 -19.7894 -19.9635 17.4029 -6378 6 54.0798 35.0308 20.3994 -2.843 -1.86615 -11.5734 -6379 4 53.8804 34.0877 20.4832 1.52986 -2.36109 -0.337181 -6380 4 53.937 35.2424 19.4598 0.882668 -0.831705 10.9264 -6381 6 42.0694 14.2202 28.4717 21.1483 -3.98018 21.7174 -6382 4 41.9885 13.9669 29.4143 -10.3093 2.59547 -11.4583 -6383 4 43.02 14.3987 28.405 -3.82604 1.35242 -7.96462 -6384 6 34.8498 7.69636 26.7062 10.2576 -3.81921 3.94078 -6385 4 35.6291 7.30563 27.124 0.895866 5.46509 7.50645 -6386 4 34.5698 7.0105 26.0965 -7.64543 -1.95318 -6.87837 -6387 6 49.6738 30.7035 23.8555 -19.3272 -4.41511 -13.3992 -6388 4 50.4901 31.166 23.8286 28.3544 13.2291 -0.764283 -6389 4 49.8241 29.9642 24.4268 4.30872 -17.0733 16.2757 -6390 6 50.9008 7.796 14.1645 9.55664 -5.64416 8.78132 -6391 4 50.8079 7.01141 13.6383 2.57079 -23.1487 -4.84087 -6392 4 50.5017 8.45024 13.6177 -13.1237 27.0593 -11.2067 -6393 6 4.26801 39.4668 27.8349 5.05862 -9.29033 0.915363 -6394 4 3.69733 40.2352 27.9464 -2.13812 3.43039 0.251988 -6395 4 3.85787 38.9439 27.1453 -8.48589 -4.99062 -8.23097 -6396 6 8.74801 32.8245 8.20645 -16.3778 -23.5545 -4.64115 -6397 4 8.1587 32.1369 7.77132 15.1044 25.0089 5.08958 -6398 4 8.83862 33.6223 7.65804 -4.44885 -3.27239 -3.39484 -6399 6 52.9644 25.4956 9.38778 -23.0628 41.5097 8.07386 -6400 4 51.9653 25.4466 9.50894 36.2156 4.27363 -7.84863 -6401 4 53.1697 26.4737 9.50477 -8.20239 -39.1491 -3.41364 -6402 6 29.5595 36.7246 19.4744 18.9803 -2.04176 16.4704 -6403 4 29.6949 37.303 18.726 -4.20274 3.37351 -9.90607 -6404 4 30.4598 36.6303 19.854 -15.3589 -5.02994 0.251134 -6405 6 52.32 36.0811 25.1124 8.57954 -21.5781 -32.5589 -6406 4 53.081 35.9362 25.6725 3.50304 3.9365 6.54391 -6407 4 51.6308 36.4579 25.6293 -16.5409 10.2166 18.3955 -6408 6 21.1806 15.7021 31.1799 -1.73968 4.64344 -14.8668 -6409 4 20.7524 16.2958 30.5301 6.89899 -9.15256 14.6363 -6410 4 20.4997 15.2544 31.7027 -1.32541 3.0922 -5.22806 -6411 6 10.6615 22.4234 39.4446 2.77058 -10.3375 -21.7461 -6412 4 10.8237 22.5242 38.4595 -6.54577 -4.89624 27.0726 -6413 4 10.2823 21.5329 39.6036 8.10661 10.4602 -7.72978 -6414 6 25.1119 11.6683 22.7275 17.9584 10.1803 -43.002 -6415 4 25.2932 11.5881 23.6503 -10.3644 -4.73542 30.1579 -6416 4 24.2275 11.4525 22.4127 -3.04384 -6.16919 15.0614 -6417 6 31.7847 10.4664 2.90738 14.6232 4.92747 -25.5509 -6418 4 32.6367 10.8084 3.16838 3.35352 3.27745 17.8769 -6419 4 31.9203 10.4929 1.94425 -15.217 -5.45404 8.94289 -6420 6 52.4827 36.4345 22.1596 -7.80713 -36.8893 3.58418 -6421 4 53.0619 36.0081 21.4904 -7.85296 7.00584 7.09748 -6422 4 52.1113 35.6558 22.6625 11.8438 27.843 -13.8236 -6423 6 46.2218 40.0356 27.0002 3.00948 19.3103 18.0239 -6424 4 46.4695 39.2891 26.4839 7.60887 -23.2108 -12.3358 -6425 4 45.8298 40.6551 26.3816 -4.98516 2.75312 2.41297 -6426 6 24.0859 36.731 39.1057 28.0861 3.14637 -13.7231 -6427 4 23.7868 35.8298 38.9338 -5.18553 -0.74556 5.28182 -6428 4 23.4629 37.185 39.6652 -17.6872 -1.49015 10.8999 -6429 6 22.3474 7.42423 31.8108 -22.1464 -34.764 6.81692 -6430 4 22.3426 8.34479 32.0749 -0.491553 12.3501 5.32307 -6431 4 21.6443 6.94951 32.3421 24.5486 22.6275 -17.4273 -6432 6 14.3601 18.3609 4.10227 -5.91068 -17.6869 34.0105 -6433 4 14.0198 17.4467 4.00899 4.58845 16.3972 -3.13031 -6434 4 14.1964 18.4938 5.07185 10.0688 2.42213 -23.7444 -6435 6 27.3176 38.4584 0.118061 26.6324 1.72941 22.4386 -6436 4 26.8721 39.2229 0.514978 -6.24738 0.955789 -1.68833 -6437 4 28.1825 38.4197 0.615747 -27.5588 -2.17115 -12.0629 -6438 6 18.6641 0.153005 12.2455 -30.1585 11.9093 7.70812 -6439 4 17.6838 0.288413 12.4195 29.795 -10.6896 -3.23208 -6440 4 18.9224 41.3021 12.7767 -6.14336 -8.14908 8.56265 -6441 6 49.4289 24.9791 25.34 -2.93287 6.40986 -7.21031 -6442 4 48.5336 24.6845 25.5066 -4.79022 -10.2209 3.00881 -6443 4 49.2657 25.7332 24.7569 10.0796 0.538989 -0.302405 -6444 6 52.0657 20.2866 15.752 -30.988 -5.77477 12.2451 -6445 4 52.9883 20.4648 15.7877 30.7647 6.19501 2.10932 -6446 4 51.7487 20.318 16.6754 2.59628 0.707672 -8.61894 -6447 6 49.6694 15.6466 38.5033 -2.36871 5.8496 0.21755 -6448 4 49.1634 15.9354 37.7317 2.81773 -6.75889 -8.88584 -6449 4 49.3364 16.2327 39.1899 -1.1635 1.82265 11.9188 -6450 6 15.9209 23.7098 13.4125 14.0576 3.0382 28.6395 -6451 4 16.4576 23.7581 14.2247 -6.14337 -14.5589 -15.9509 -6452 4 15.4928 24.5639 13.4473 -12.8057 7.70559 -12.0572 -6453 6 14.3535 29.1644 14.3158 -5.44214 8.41065 -10.6214 -6454 4 14.1107 29.5404 13.4323 4.3831 -8.60004 22.5031 -6455 4 14.1668 29.874 14.9595 1.02369 -3.68708 -8.8215 -6456 6 30.4209 19.8501 16.8941 13.513 -29.8099 -4.40702 -6457 4 30.8419 19.6061 17.7309 -1.16118 4.00396 0.0836579 -6458 4 29.8867 20.6126 17.0073 -13.0379 22.0094 6.56408 -6459 6 21.3171 21.0315 23.1347 13.77 4.04154 19.3244 -6460 4 22.2214 21.2364 23.4619 -15.8088 -1.32345 -6.31481 -6461 4 20.7299 21.1568 23.8987 5.07857 1.54253 -3.54042 -6462 6 32.3393 0.431439 25.2563 20.1104 -9.0179 2.05206 -6463 4 32.3376 0.357033 24.2893 -5.83171 4.85221 4.50445 -6464 4 31.4939 0.740536 25.5658 -20.5297 5.12544 -3.04931 -6465 6 26.1412 32.4208 27.5133 11.9844 8.82666 12.5058 -6466 4 25.6297 33.2181 27.3271 -3.7928 0.326337 -6.17907 -6467 4 25.9506 31.7475 26.8638 -6.12498 -3.36782 -14.5181 -6468 6 31.6886 23.0183 41.4596 0.904697 7.64904 11.3452 -6469 4 32.5758 22.6752 41.6838 -11.075 0.532718 -2.08438 -6470 4 31.0649 22.7115 0.227606 5.71652 1.16966 -4.3825 -6471 6 54.3662 17.838 10.7289 1.16641 13.6113 28.4031 -6472 4 53.5784 18.2682 10.4091 -15.835 11.3767 1.3744 -6473 4 54.5574 17.2244 10.05 12.0924 -25.2322 -22.7117 -6474 6 15.4007 28.5656 8.62044 -26.1749 5.76845 -41.3303 -6475 4 14.7273 28.9702 8.01425 13.7656 -2.21873 23.1298 -6476 4 15.8479 27.9621 8.001 5.22436 1.48231 12.0756 -6477 6 21.9302 22.318 27.6758 1.68517 -22.7815 -10.3197 -6478 4 22.2029 23.2377 27.6948 5.32233 7.77922 8.4028 -6479 4 21.9507 21.9579 28.5708 1.77406 4.33165 6.10734 -6480 6 2.9439 17.0434 8.14058 1.94164 -24.3442 -12.3304 -6481 4 3.71771 17.0381 7.53295 -10.9103 8.58946 10.7103 -6482 4 2.9095 17.8301 8.67828 12.1388 15.179 1.9509 -6483 6 27.5776 18.2769 3.9771 26.0492 -34.2565 5.18616 -6484 4 26.8914 18.9079 3.85686 -19.1066 25.6869 -8.0303 -6485 4 28.3968 18.6065 3.57961 -12.2542 3.89161 2.52414 -6486 6 24.7648 24.5394 8.45172 0.675902 5.99664 -6.73781 -6487 4 25.0691 23.6382 8.29185 0.995795 -2.08458 0.0885467 -6488 4 24.6379 24.6158 9.40394 1.7631 1.80546 -0.516948 -6489 6 41.9985 30.4652 13.7873 -12.418 22.2399 8.0521 -6490 4 42.948 30.5766 13.6065 -4.54142 -18.1038 -0.632901 -6491 4 41.6543 29.5567 13.7855 17.2179 -0.450275 -1.52495 -6492 6 15.7003 34.688 41.5836 22.5583 -4.71252 2.77114 -6493 4 16.4414 35.3131 41.7067 -7.89455 1.74939 1.29748 -6494 4 14.9091 35.1782 41.7999 -10.5684 8.94915 5.66738 -6495 6 11.14 19.7709 40.5827 8.16812 -24.8495 -13.7269 -6496 4 12.099 19.6958 40.4335 -6.97557 5.6239 6.72769 -6497 4 10.8269 18.8658 40.3418 -4.09458 16.1616 8.77151 -6498 6 47.4994 34.5266 14.3059 -7.29954 -13.2064 -47.3862 -6499 4 46.9486 35.2618 14.0194 -1.26876 14.2822 14.9014 -6500 4 47.5134 34.0178 13.447 14.161 -1.19014 30.6955 -6501 6 12.4113 26.9599 28.4986 7.53387 -39.615 -11.3807 -6502 4 13.2389 26.8759 29.0383 -9.69033 -7.26437 -10.917 -6503 4 12.3547 26.143 27.8911 8.77392 33.3418 27.7102 -6504 6 27.6324 16.2078 39.8226 -15.7166 38.3334 10.2244 -6505 4 27.1738 15.4871 40.2515 -0.529449 -16.0233 0.418904 -6506 4 28.2783 15.8881 39.2072 13.4358 -18.0852 -11.4488 -6507 6 33.41 31.2223 27.2648 1.06056 32.1352 -34.8736 -6508 4 34.1408 31.8147 27.4795 4.37007 -7.45055 8.12396 -6509 4 32.9956 31.7298 26.5244 2.74339 -19.701 12.9858 -6510 6 39.1079 39.5697 31.9277 -2.55925 2.09297 0.92959 -6511 4 38.7672 39.6549 31.0188 2.43701 -1.71218 7.87361 -6512 4 38.6143 40.212 32.4659 5.60044 -5.69156 -1.85126 -6513 6 22.8777 16.5449 19.9566 -5.65986 -8.80894 -1.36967 -6514 4 23.3352 15.8067 20.4264 -14.7096 4.17994 -10.0586 -6515 4 22.0919 16.2116 19.4632 15.4216 -6.99735 9.66589 -6516 6 23.9693 21.8661 10.5894 -36.2244 3.36606 3.40233 -6517 4 22.9782 21.9097 10.6297 20.8239 3.29656 -5.85881 -6518 4 24.1356 21.2379 11.286 10.3432 -8.66819 12.8402 -6519 6 40.1777 25.441 2.79106 -10.2872 18.2283 6.37262 -6520 4 40.1705 25.0132 3.63888 8.49445 -17.5146 10.0011 -6521 4 39.7592 26.2809 3.01477 -1.02299 2.45309 -8.63041 -6522 6 15.0237 19.7749 9.41859 -29.0071 17.4399 5.80075 -6523 4 14.7228 20.7104 9.1599 7.38 -34.1593 9.70733 -6524 4 14.2459 19.2857 9.84339 25.5779 21.3804 -17.4983 -6525 6 7.16152 24.8628 0.123297 -7.02966 -3.56682 11.7049 -6526 4 7.96668 24.8036 41.5398 15.214 -7.46464 -23.6733 -6527 4 7.46323 25.2953 0.914133 -6.27594 4.44234 13.0485 -6528 6 43.3927 10.9201 31.3407 25.4071 10.106 7.84859 -6529 4 43.8098 10.8609 30.45 -7.40798 -0.791197 19.4909 -6530 4 44.1598 10.9733 31.9767 -21.009 -0.343387 -21.8186 -6531 6 13.8353 19.068 27.8558 -6.19586 12.3763 0.85665 -6532 4 12.975 18.7858 28.1864 -1.64107 2.23065 2.52451 -6533 4 13.8413 20.053 27.8412 2.88957 -13.8419 -2.19198 -6534 6 3.4728 19.5924 9.6022 -44.5705 9.69836 1.75794 -6535 4 2.70361 20.0095 10.0844 20.5969 -13.9146 -9.89239 -6536 4 4.25765 19.8234 10.0844 13.5534 0.0599395 5.99295 -6537 6 51.0213 19.4268 7.70955 2.43945 12.0622 -23.2725 -6538 4 50.6325 20.2627 7.28999 21.6228 -31.5555 10.1722 -6539 4 51.8004 19.115 7.16203 -27.7652 18.9123 7.69536 -6540 6 42.2139 2.59999 10.4154 11.3377 -7.01405 -0.847173 -6541 4 43.144 2.57533 10.7556 -19.516 1.89174 -10.2127 -6542 4 42.1979 2.39197 9.45142 9.27815 6.14572 20.7298 -6543 6 30.7794 6.42968 35.1975 -13.4378 -7.3385 -2.08895 -6544 4 29.8146 6.43175 35.3648 9.73054 -4.02703 -1.93701 -6545 4 31.052 5.50707 35.0427 -6.67101 6.52405 0.860042 -6546 6 52.8733 36.9495 18.5906 -4.95733 10.1612 -6.16245 -6547 4 51.9909 36.5548 18.5738 -2.549 -5.51132 1.40056 -6548 4 52.7192 37.8514 18.247 7.64894 -10.0112 4.74408 -6549 6 44.2058 6.2999 1.04709 5.21291 8.10008 11.2107 -6550 4 44.5368 6.97198 1.69742 -2.24215 -10.2401 -12.34 -6551 4 44.9393 6.09517 0.464894 1.54959 1.89788 1.1267 -6552 6 42.1369 38.61 31.1886 17.67 -9.24899 26.4806 -6553 4 41.7623 38.8803 30.3687 -14.3725 6.55505 -24.001 -6554 4 41.498 38.8614 31.8609 -3.32676 4.75778 -0.202389 -6555 6 43.7164 12.7972 9.05712 5.81528 3.72875 -30.711 -6556 4 43.3247 13.6946 8.89573 9.87346 -21.9812 3.16194 -6557 4 44.14 12.4709 8.19462 -12.6006 16.8915 32.7492 -6558 6 13.3844 0.443398 6.51083 -17.4423 24 5.83044 -6559 4 13.1471 1.18968 7.12521 11.9969 -17.0568 -16.1514 -6560 4 13.404 0.824606 5.60344 -0.330864 -2.32474 10.3957 -6561 6 16.1322 13.2809 10.2756 -7.67495 0.483234 -7.74316 -6562 4 16.9315 12.7781 10.4995 -2.28882 -8.98658 -2.43525 -6563 4 15.4389 12.669 9.92885 16.2568 3.72445 6.60733 -6564 6 1.59909 8.47465 4.69565 -12.106 -24.0688 17.9122 -6565 4 1.97809 9.06493 4.05503 13.7499 12.9224 -12.6029 -6566 4 2.17818 8.51684 5.47441 1.43398 4.73372 -5.14276 -6567 6 37.2847 1.71984 10.5234 11.0189 -27.5723 -13.4042 -6568 4 37.2468 2.67416 10.4778 -4.00861 9.27523 10.0347 -6569 4 36.8996 1.35439 11.335 -2.27729 16.2243 3.90618 -6570 6 53.8329 9.87891 17.6846 -38.3798 -30.924 7.14602 -6571 4 54.5301 10.0186 17.0634 18.0368 1.02749 -18.7159 -6572 4 53.3473 9.06138 17.3773 12.8854 20.2391 7.24153 -6573 6 45.4804 30.6107 15.8042 -8.04753 0.598448 7.23065 -6574 4 44.8245 31.2304 16.205 12.7241 -16.0174 -7.51778 -6575 4 45.2045 29.6903 15.9459 -0.384376 11.4708 0.631615 -6576 6 39.9212 16.643 33.8508 -27.7636 -7.17353 -19.4615 -6577 4 39.1766 17.1755 33.458 21.1378 -12.4278 10.7513 -6578 4 39.8244 15.7487 33.4296 5.23768 21.8708 14.061 -6579 6 32.8655 24.7639 27.9361 20.284 59.6053 -7.49862 -6580 4 33.6165 25.1458 28.4374 -8.60268 -19.6727 -0.650124 -6581 4 32.6313 25.5876 27.4183 -1.69816 -34.155 10.7383 -6582 6 7.87466 31.6143 24.1101 1.9117 20.6925 26.3443 -6583 4 7.66972 30.8573 24.7192 5.27436 26.873 -8.7819 -6584 4 7.9908 32.4716 24.6533 -12.57 -44.6195 -20.0842 -6585 6 43.5378 41.3358 15.8218 9.28004 -2.58796 -1.50951 -6586 4 43.1443 0.2957 15.6997 -2.19094 2.48586 -2.7957 -6587 4 44.4004 41.3722 15.3768 -7.99823 -0.449815 2.36698 -6588 6 20.0371 29.5453 33.205 3.08504 -20.5033 -11.6211 -6589 4 20.9096 29.2965 33.5637 -2.90058 10.2459 9.35691 -6590 4 19.6251 30.2513 33.706 8.84517 7.80605 8.87396 -6591 6 43.4117 21.4438 18.6347 -11.1342 -15.0059 14.8538 -6592 4 43.0276 21.2687 19.5098 8.56326 4.46648 -0.801958 -6593 4 42.8532 20.9111 18.0542 1.01153 2.95656 -9.2223 -6594 6 3.44653 19.1197 18.4217 23.6769 1.99723 9.81042 -6595 4 3.20802 20.045 18.3207 -2.32682 2.96104 -2.33529 -6596 4 2.63398 18.6303 18.3598 -12.7596 -8.76931 -2.32568 -6597 6 41.6678 38.1102 16.3244 12.531 -42.2252 -39.0953 -6598 4 41.9368 37.3879 15.641 -15.3799 38.9729 30.6603 -6599 4 42.3331 38.0554 17.0146 -0.0757724 1.18921 2.99625 -6600 6 7.55561 36.3978 10.4983 -3.44092 15.1931 -1.45671 -6601 4 6.72339 36.2337 10.0108 12.3142 -8.52859 4.51616 -6602 4 7.946 35.5335 10.7116 -10.6452 2.04557 -4.50299 -6603 6 36.2515 19.1074 34.8142 -43.7142 -17.0801 -27.3746 -6604 4 35.3817 19.3303 34.3863 23.1726 -6.06315 12.306 -6605 4 36.4633 19.8781 35.3097 10.3 22.3537 14.1292 -6606 6 53.5678 24.9372 12.6442 30.4342 18.5181 -32.2976 -6607 4 53.8348 25.8921 12.6266 -11.9077 -21.6197 10.5864 -6608 4 54.0165 24.5977 11.8224 -16.4724 -4.37861 26.9125 -6609 6 31.6766 10.443 21.0806 4.21881 -9.06253 -2.47208 -6610 4 31.4001 9.76622 21.7243 -7.70504 9.2495 -8.08332 -6611 4 30.9288 10.6617 20.4921 1.78432 -8.02731 8.28605 -6612 6 18.1094 28.7798 17.1891 14.7524 22.0605 -19.6834 -6613 4 19.0758 28.769 16.9872 -20.2742 -2.10771 9.28657 -6614 4 17.7731 29.5847 16.7123 5.43167 -23.0331 15.3038 -6615 6 21.675 18.2354 36.8765 16.12 -15.5286 8.52342 -6616 4 22.5529 17.9072 36.565 -22.4082 10.693 4.11156 -6617 4 21.5572 17.762 37.7329 -6.04816 8.67317 -10.9669 -6618 6 25.0658 19.0188 34.2159 -51.8076 2.97265 19.7815 -6619 4 24.747 18.4039 34.9114 5.38902 10.2451 -10.362 -6620 4 25.8774 18.6629 33.96 52.7001 -22.9877 -15.275 -6621 6 15.5692 13.0234 5.56242 -6.58245 2.44228 -13.4315 -6622 4 15.9945 13.4237 6.33643 -0.981395 -11.5063 2.18089 -6623 4 15.4281 12.0558 5.58603 5.20341 13.6823 8.40676 -6624 6 54.4716 41.6235 14.8012 14.2089 2.8312 2.80672 -6625 4 54.7869 41.5367 15.7234 -10.706 -4.16636 -8.71187 -6626 4 53.6678 41.1066 14.6963 -6.31993 -3.99892 7.53898 -6627 6 1.6781 26.4654 31.3743 5.67012 -21.4195 51.4057 -6628 4 2.55869 26.331 31.7713 -6.41431 -1.4007 -7.54986 -6629 4 1.81482 26.7235 30.4972 11.6805 15.9936 -52.9786 -6630 6 32.3382 37.285 29.6856 -26.7217 17.5069 7.43983 -6631 4 31.5807 37.8924 29.918 20.5429 -15.6126 -5.39856 -6632 4 33.128 37.6701 30.0913 2.74033 -1.11204 0.131524 -6633 6 52.7155 21.0369 22.8986 -26.6856 13.1044 -7.83906 -6634 4 51.927 21.5218 22.5308 17.9584 -10.8856 16.9396 -6635 4 53.1096 20.6236 22.131 10.0871 -9.76004 -3.40095 -6636 6 32.7546 28.5936 40.5151 -16.005 5.57574 20.6704 -6637 4 31.9696 29.0914 40.2712 1.08408 5.35728 -15.103 -6638 4 32.4826 28.2925 41.3957 13.2257 -7.23298 -6.66392 -6639 6 23.6064 32.0719 16.3529 6.2601 0.887785 0.577407 -6640 4 24.375 31.9361 16.9584 -22.6405 4.1158 -3.2487 -6641 4 22.7879 32.3052 16.8361 12.3926 -5.56708 -0.502672 -6642 6 37.5201 9.16809 29.9792 -2.73778 -7.47015 7.66604 -6643 4 36.7801 8.78215 30.4957 3.311 11.363 -11.2805 -6644 4 37.2059 9.98527 29.541 -5.1069 -9.85197 8.55889 -6645 6 2.27705 24.391 14.5477 -18.8311 -23.8216 -15.5117 -6646 4 1.75426 24.0938 15.3142 10.0576 11.8704 2.19803 -6647 4 1.95568 23.7778 13.8474 11.5886 17.7779 11.9828 -6648 6 27.3753 28.7961 24.7726 7.21008 -25.2057 -20.8265 -6649 4 27.1644 28.4274 25.6317 -2.92196 -0.0765173 10.3399 -6650 4 27.4291 28.0161 24.1505 1.02404 24.316 14.9 -6651 6 16.7879 2.56531 14.3086 11.9129 14.2285 -1.69346 -6652 4 17.7185 2.38196 14.3175 13.0278 5.32386 8.84309 -6653 4 16.4775 1.81817 13.8231 -22.7045 -15.6449 -12.1127 -6654 6 21.8022 39.8027 36.8001 40.4582 11.674 1.33338 -6655 4 22.755 39.5599 36.9347 -17 12.4394 -0.288792 -6656 4 21.461 38.9709 36.5396 -21.7153 -28.8447 -11.0269 -6657 6 14.0716 6.47232 41.542 21.0202 -14.2424 -6.97231 -6658 4 14.9696 6.10406 41.5939 -1.81915 -4.72532 -7.76656 -6659 4 14.0403 6.99701 0.421866 -13.8031 9.98176 13.4178 -6660 6 14.5555 16.5106 9.31543 20.3876 4.44524 4.12907 -6661 4 15.4025 16.5964 9.78828 0.864554 -6.42184 -12.9633 -6662 4 13.9847 17.046 9.86181 -12.8914 3.93145 3.80898 -6663 6 8.66171 23.4817 30.5575 -0.244333 -0.896371 32.8135 -6664 4 9.54353 23.6001 30.2398 18.7576 4.73722 -27.2602 -6665 4 8.85707 23.3999 31.5064 -16.6456 -3.41855 -0.290363 -6666 6 37.6497 2.07069 20.0046 29.2824 -26.1096 14.9164 -6667 4 37.0584 2.2163 19.2662 -13.6051 13.4744 -1.64318 -6668 4 37.4656 2.68422 20.7276 -9.488 6.31449 -9.7769 -6669 6 42.7264 7.54802 8.0174 22.2735 -23.3375 63.966 -6670 4 43.1898 7.96838 7.30926 14.9789 10.8108 -11.9713 -6671 4 43.3711 7.43923 8.8454 -34.4126 10.1207 -51.4479 -6672 6 38.5672 29.6578 6.85692 25.3422 5.29964 1.58487 -6673 4 38.5311 29.2984 7.75245 -9.71234 0.328663 -2.10015 -6674 4 37.7248 29.5682 6.41889 -15.2832 -4.18317 0.54199 -6675 6 42.5348 15.7114 39.7967 1.15785 13.3588 -25.5786 -6676 4 42.7129 16.6429 39.5831 1.88136 -1.51067 11.9166 -6677 4 42.2359 15.3735 38.9271 3.70013 -4.77916 17.2749 -6678 6 19.8546 7.43685 22.0566 -22.5975 2.81071 25.7956 -6679 4 19.2803 8.13273 21.6746 8.521 -7.13733 1.21439 -6680 4 19.4015 7.21173 22.9242 12.7412 8.86068 -31.9054 -6681 6 27.421 3.23371 12.5304 27.0524 21.0752 -24.489 -6682 4 28.3367 3.35644 12.1327 -27.9555 -7.8832 14.1518 -6683 4 27.3543 2.31638 12.8154 4.42645 -1.52034 -0.990676 -6684 6 34.4011 6.50186 34.3664 -16.3424 -2.90191 9.94761 -6685 4 33.6712 7.15225 34.4215 6.78416 -7.62851 1.00734 -6686 4 34.1394 5.7575 34.9538 2.66911 12.7001 -5.69623 -6687 6 9.88701 27.9536 39.7574 38.1218 -1.21446 9.36845 -6688 4 10.8313 27.9815 40.1009 -35.4969 -5.93471 -11.3457 -6689 4 9.7403 28.8357 39.397 -3.9481 4.17466 -3.11552 -6690 6 50.5681 22.1235 6.40489 -3.33101 1.51672 6.50125 -6691 4 51.5163 22.3536 6.46403 -14.0562 3.33212 10.0382 -6692 4 50.0608 22.5915 7.10741 15.6039 -2.37345 -9.267 -6693 6 47.1098 11.477 30.0359 32.4056 2.61276 18.961 -6694 4 47.3696 10.9259 30.8115 -10.3246 7.95021 -16.9085 -6695 4 46.3045 11.1726 29.6407 -20.48 -14.5539 -1.24473 -6696 6 25.9367 28.4654 9.80931 -8.38409 -27.2904 31.5361 -6697 4 26.8395 28.2564 10.1264 -14.1867 1.81997 -4.27567 -6698 4 25.3175 27.9176 10.3882 19.4096 21.4407 -17.1039 -6699 6 35.4417 36.6052 19.4431 3.65383 9.51374 12.5698 -6700 4 35.4442 36.5892 20.4356 4.35023 4.13201 -20.4161 -6701 4 36.0823 37.2978 19.1702 -7.18083 -5.57131 7.61291 -6702 6 39.0947 17.861 12.3005 -1.37104 18.7141 6.38745 -6703 4 39.0516 18.8013 12.5757 6.4741 -5.57949 -8.41576 -6704 4 38.3925 17.481 12.8252 -9.64523 -10.3587 5.73293 -6705 6 2.67895 27.1328 2.39169 -0.469231 -1.96621 -7.87892 -6706 4 2.01695 27.5866 1.84113 6.06579 -3.44887 4.00529 -6707 4 2.54603 27.3828 3.31988 1.36543 -1.57126 -4.01383 -6708 6 12.3125 32.2183 21.5204 7.73608 31.3279 -34.5621 -6709 4 12.8754 32.1648 22.302 -15.5368 -9.13091 6.69049 -6710 4 11.4514 31.7997 21.5885 -0.151568 -8.94455 23.3893 -6711 6 32.8824 32.3641 8.46179 -18.8611 4.30442 3.1153 -6712 4 33.4241 32.9657 8.96292 17.2175 7.79223 5.74753 -6713 4 32.0088 32.7748 8.50666 0.635289 -6.40729 -7.5616 -6714 6 12.649 6.44414 31.9754 -2.83404 4.50046 10.0363 -6715 4 13.204 6.32185 31.2101 8.19857 -2.9014 -11.0209 -6716 4 11.7563 6.235 31.704 -2.09981 -3.08597 -3.85403 -6717 6 41.3663 27.7408 14.044 -7.1512 -14.0341 -18.9391 -6718 4 41.8178 27.3798 13.2339 -12.2472 13.3456 19.5442 -6719 4 40.4043 27.5413 13.9741 19.5004 0.843126 1.31278 -6720 6 6.61204 16.505 25.4358 4.38086 10.1107 -4.22872 -6721 4 7.40634 15.95 25.3995 -3.52048 -0.326181 -5.74655 -6722 4 5.93615 16.0015 24.9584 5.4209 -2.01242 3.85811 -6723 6 21.7595 39.2992 13.3504 -47.5104 6.20728 42.9111 -6724 4 22.3466 39.2605 12.6295 26.4998 6.28224 -34.1528 -6725 4 21.7095 40.2078 13.7281 10.6984 -16.5323 -14.9329 -6726 6 34.8487 6.01484 6.95222 -29.6963 0.326386 -14.1862 -6727 4 33.862 5.88861 6.88689 25.1099 2.0969 11.0318 -6728 4 35.0754 6.24807 6.0365 6.49139 -1.48305 5.74594 -6729 6 33.0274 30.4243 33.1708 -20.2868 -13.6057 -33.0226 -6730 4 32.107 30.5622 32.8069 24.6222 -1.48625 15.7647 -6731 4 33.1252 31.0225 33.8918 -2.19017 18.1524 16.6028 -6732 6 15.459 32.4153 12.1907 25.026 -14.7999 12.6103 -6733 4 16.3707 32.0454 12.2858 -22.5133 7.43237 -2.39957 -6734 4 15.4871 32.8857 11.3664 4.63911 10.1509 -16.175 -6735 6 12.6896 26.6018 21.3639 -15.0944 -25.6853 -2.70918 -6736 4 11.948 26.0906 21.6799 0.937138 -29.673 -19.3981 -6737 4 12.542 27.2759 21.9777 19.0907 58.813 21.5342 -6738 6 47.0229 36.3064 29.9951 -7.32095 -4.41829 24.4392 -6739 4 47.4263 37.0889 30.4354 -10.9743 -13.05 -1.23566 -6740 4 46.4286 35.8162 30.6445 23.161 23.2616 -16.2608 -6741 6 0.29284 12.714 23.4069 -35.5625 7.7859 6.41586 -6742 4 0.591011 11.8915 23 -3.04289 0.952694 -0.179009 -6743 4 54.2726 12.6526 23.4069 36.7156 0.482893 -0.227565 -6744 6 54.1717 18.9252 21.5683 -50.0663 20.0699 0.290361 -6745 4 -0.00468748 18.6783 21.9698 30.2345 -16.5238 -1.58257 -6746 4 54.0846 18.73 20.626 15.626 -5.42297 0.74208 -6747 6 25.7258 24.2992 23.7444 19.803 -45.4072 -0.235584 -6748 4 25.1532 23.5493 23.4006 14.0979 28.9064 13.4272 -6749 4 26.557 23.8171 24.0636 -29.432 23.3848 -10.2309 -6750 6 11.8983 29.0288 26.8736 6.09277 -0.515715 3.71925 -6751 4 12.595 29.6797 27.0784 -3.35093 -5.68029 1.25498 -6752 4 11.9864 28.3255 27.5444 1.01315 10.8055 -7.75858 -6753 6 47.9911 35.8567 10.6981 8.08413 -4.02984 -21.6227 -6754 4 48.7745 35.7734 10.1229 -13.6418 -1.85084 -2.1863 -6755 4 48.3792 36.2903 11.4463 -1.30569 7.34959 21.4512 -6756 6 47.672 29.8438 36.9511 38.562 -32.0587 -16.7646 -6757 4 48.1514 29.311 36.2244 -26.8687 25.3781 26.6073 -6758 4 46.9232 30.3209 36.5927 -0.690739 -0.634879 -8.58348 -6759 6 7.33835 12.3416 10.615 -8.89583 -3.33234 -10.1121 -6760 4 7.22469 12.7824 9.73793 -1.24183 -8.23722 19.221 -6761 4 6.50851 12.5236 11.1156 17.4449 -0.896679 -14.5349 -6762 6 52.929 15.961 4.90278 -10.2898 -1.28264 -8.50781 -6763 4 53.0348 16.1145 3.95774 -1.18717 -0.815743 4.35872 -6764 4 53.806 16.0238 5.26597 15.814 -0.370642 9.21047 -6765 6 10.6777 16.9586 34.6035 -55.1347 -38.7426 5.67968 -6766 4 10.8984 16.7766 35.5088 23.7364 14.024 15.8473 -6767 4 9.8802 16.3472 34.5582 30.0556 27.9196 -18.3163 -6768 6 25.1377 31.056 36.0048 1.42921 -10.848 -28.6765 -6769 4 25.7744 31.7772 36.0714 -0.417948 1.95283 3.18329 -6770 4 25.3475 30.6244 35.1463 -8.66047 8.51414 18.9355 -6771 6 34.0941 21.8921 41.4705 -2.59948 8.49748 21.8065 -6772 4 33.8376 21.0023 41.2487 -0.891159 -17.6747 -3.00217 -6773 4 34.5263 22.2081 40.6953 10.3371 11.5397 -24.1167 -6774 6 15.7674 30.0637 1.25444 19.4532 4.17941 -23.0135 -6775 4 15.204 30.4318 1.91689 -16.4157 4.77211 21.8875 -6776 4 16.1981 30.8773 0.915598 -5.77798 -19.2538 1.08217 -6777 6 29.5177 27.8662 16.6069 -21.9867 -20.8772 26.8051 -6778 4 29.4575 26.8938 16.8925 2.72258 42.9501 -5.19299 -6779 4 28.8337 28.3532 17.1557 16.905 -14.8206 -13.8895 -6780 6 39.6418 9.77683 0.55649 6.97543 15.8838 23.3716 -6781 4 40.1108 10.6055 0.868863 -11.4024 -23.0197 -7.66085 -6782 4 39.4946 9.23542 1.36828 3.21978 8.9832 -14.2415 -6783 6 1.52158 31.8692 16.4183 -13.8984 7.04184 27.8471 -6784 4 2.05742 32.2974 15.7673 16.5414 8.9668 -16.2997 -6785 4 1.54493 30.9444 16.2035 3.31157 -20.7597 -8.56027 -6786 6 8.73651 39.8559 25.0424 -4.76165 -15.5453 0.0774869 -6787 4 8.05377 39.648 25.6948 0.177415 -5.7342 -2.33302 -6788 4 8.86744 40.7877 25.1714 9.39418 20.2019 -3.50565 -6789 6 42.3206 10.2864 9.76098 2.95973 19.1246 -1.63703 -6790 4 42.201 10.133 10.7061 4.21692 -0.996774 -0.328573 -6791 4 42.7677 11.1578 9.6855 -5.09192 -13.1904 -0.0451331 -6792 6 13.2407 7.61713 1.96996 -7.39862 -1.41628 8.88927 -6793 4 13.9913 7.91748 2.51852 -7.45732 -2.50241 0.703823 -6794 4 12.5579 7.21318 2.54911 15.3337 9.06064 -6.21655 -6795 6 18.7418 40.0591 14.2229 14.6643 6.60726 6.61579 -6796 4 19.3344 39.8885 14.9901 -13.3575 3.17545 -12.3588 -6797 4 17.9636 39.4956 14.2872 3.6042 -5.87931 7.54738 -6798 6 20.1073 14.0529 38.5598 27.8117 -61.2518 1.76132 -6799 4 20.1641 13.6472 37.6602 -4.05869 13.902 17.7453 -6800 4 19.784 14.907 38.4293 -21.3136 56.4597 -12.4562 -6801 6 22.6529 28.8869 34.0687 6.58134 -12.6264 20.4136 -6802 4 23.051 28.2341 33.486 -0.980474 2.102 -8.59088 -6803 4 22.967 28.5961 34.9503 -6.50134 7.38476 -6.63172 -6804 6 22.6736 4.71248 5.24178 -0.00794307 -2.96021 -16.86 -6805 4 22.1728 3.90748 5.48978 2.26378 16.1145 9.27739 -6806 4 22.7088 5.35566 5.95806 -4.05577 -5.29394 11.9552 -6807 6 23.6374 34.0001 38.3917 50.061 26.1352 -20.3518 -6808 4 22.8137 33.6238 38.6177 -41.7704 -11.5062 -0.965889 -6809 4 23.6153 34.3835 37.4812 -9.56218 -11.3792 16.4738 -6810 6 48.3816 21.3644 17.2759 -0.964958 21.4078 15.1884 -6811 4 48.1603 22.346 17.2347 5.31328 -30.3781 -7.15015 -6812 4 48.2799 20.9337 16.4123 -2.86285 15.3202 1.32987 -6813 6 11.5786 11.0066 8.63803 -22.8025 30.9503 41.2381 -6814 4 11.6342 10.2487 9.24135 6.24209 -4.12245 -6.65597 -6815 4 11.0653 11.6976 9.17674 20.0011 -23.9124 -25.5895 -6816 6 40.098 28.1667 33.502 25.4322 5.13826 0.328547 -6817 4 41.0532 28.3457 33.4282 -8.43417 -7.39989 8.78785 -6818 4 39.8078 28.5143 32.6608 -12.8477 1.2165 -2.93222 -6819 6 47.3852 25.6796 5.28879 12.5804 32.9376 -10.0311 -6820 4 46.4546 25.5561 5.13624 -16.8804 -10.2001 -0.268496 -6821 4 47.5232 26.6241 5.03253 2.87445 -14.5067 3.75712 -6822 6 21.6604 35.221 23.9985 9.0652 15.9564 -12.6156 -6823 4 21.5339 34.4977 24.6161 5.50034 -7.33202 6.93593 -6824 4 22.5891 35.5406 24.0132 -10.9025 -9.97729 6.37443 -6825 6 8.25067 41.5023 8.40693 4.57396 0.593767 -7.67714 -6826 4 8.14583 40.8128 7.73311 1.23406 2.32353 -0.157563 -6827 4 7.86929 41.1416 9.20784 -2.18245 3.41182 6.12515 -6828 6 16.4756 31.0916 22.2208 -15.8048 -5.76047 -3.57767 -6829 4 16.9823 30.8797 21.4186 0.224111 -1.11381 3.57708 -6830 4 17.0871 31.1495 22.9566 10.3822 -1.94934 1.40451 -6831 6 54.7052 0.441622 28.3216 30.4392 7.42547 7.16367 -6832 4 0.670225 0.280878 28.2941 -2.60978 -25.0778 -11.1355 -6833 4 54.7831 1.35385 28.5964 -22.0828 12.0381 3.63841 -6834 6 48.4365 15.3814 4.18175 16.1137 -59.8395 -8.29881 -6835 4 49.2486 15.0627 4.66696 -19.7577 20.5705 -9.22457 -6836 4 48.202 14.5739 3.61717 1.65501 39.0327 16.4105 -6837 6 34.3447 6.98096 40.4233 28.1894 -26.1309 -0.966046 -6838 4 33.5941 7.1072 39.8443 -1.28272 -2.58724 -7.46065 -6839 4 35.0352 6.39393 39.9745 -30.768 20.5054 8.50532 -6840 6 41.3452 3.36617 16.9999 -11.8967 -16.9054 2.63506 -6841 4 41.0249 2.72492 17.6694 2.1854 6.18106 -7.89089 -6842 4 41.9449 3.92974 17.49 7.08552 9.22633 4.28017 -6843 6 48.4488 20.6937 14.5344 36.1561 -40.2628 27.2518 -6844 4 47.9962 21.3635 14.0898 -25.7182 45.1623 -29.349 -6845 4 49.3977 20.8911 14.4834 -7.22111 0.680744 -3.09477 -6846 6 52.5006 28.1422 37.1181 -0.438891 10.9489 1.55023 -6847 4 53.461 28.2559 37.0441 -2.53591 -5.73983 -7.32344 -6848 4 52.1579 27.9957 36.2188 6.05301 2.29627 6.02383 -6849 6 53.8778 18.5596 18.7916 -16.4261 -54.6782 2.06415 -6850 4 54.6924 18.1462 18.492 5.89253 -2.608 -0.931268 -6851 4 54.0684 19.4623 18.7843 11.279 55.5152 0.463912 -6852 6 40.9954 39.1455 28.7887 -28.6383 -4.85259 53.4888 -6853 4 41.3933 39.2419 27.9663 30.849 7.00679 -57.5311 -6854 4 40.0484 39.2316 28.6375 -4.32997 -1.25138 -0.266272 -6855 6 38.2708 8.75593 24.2289 27.2886 -4.9888 -5.43324 -6856 4 39.2171 8.59021 23.9715 -26.3742 3.09491 7.04217 -6857 4 38.3303 9.34105 24.9905 -3.83131 2.71498 5.53525 -6858 6 2.99948 29.1469 9.63392 26.6909 -34.1608 2.5373 -6859 4 2.51216 28.7995 8.89273 -4.75194 -2.8028 -9.24178 -6860 4 2.58111 29.9575 9.82954 -15.8869 33.6035 13.3424 -6861 6 27.5773 29.2771 18.3181 4.27818 -11.5166 33.1226 -6862 4 26.7531 29.1546 17.8331 -9.3021 -0.872639 -4.78576 -6863 4 27.3558 28.9731 19.2647 9.0806 12.9475 -44.783 -6864 6 11.8527 21.1658 10.1208 3.44892 -32.1211 19.512 -6865 4 12.1978 22.0146 9.89711 8.39983 22.4635 -8.03232 -6866 4 12.4593 20.8304 10.8135 -12.0936 9.66798 -13.0295 -6867 6 16.8988 32.3014 0.299949 1.29982 1.68058 -0.586211 -6868 4 17.7043 32.7282 0.600499 13.9817 -1.747 3.00212 -6869 4 16.3216 33.0562 0.17902 -12.1561 7.80428 -5.7129 -6870 6 1.309 17.4831 22.5447 23.3848 -11.3219 -15.6007 -6871 4 1.13597 16.5744 22.1718 3.15619 19.2398 8.80125 -6872 4 2.27868 17.6899 22.4311 -25.7511 -7.40397 3.71946 -6873 6 41.5587 6.87311 29.3039 4.08196 29.5448 1.53382 -6874 4 41.6919 5.95311 29.5356 2.80206 -5.98386 3.69024 -6875 4 41.9106 7.40602 30.0483 -3.99043 -10.4039 -5.51054 -6876 6 10.5167 10.7886 13.8618 17.7458 -17.1897 13.2051 -6877 4 10.6632 11.2096 13.003 1.79898 0.261401 -4.84225 -6878 4 11.2159 10.1 14.0373 -16.1376 17.4326 -7.31573 -6879 6 39.8332 15.4952 40.8309 13.3581 4.75609 3.89566 -6880 4 39.9392 16.0809 40.0548 0.3292 -3.56753 7.15077 -6881 4 40.6564 15.5643 41.3732 -15.0531 5.58747 -11.8726 -6882 6 26.5094 19.6057 40.5003 9.17758 -2.41024 9.24949 -6883 4 27.4312 19.885 40.5187 -1.32295 2.31326 -8.74715 -6884 4 26.4504 19.08 41.3172 -10.7617 -0.025449 -2.36491 -6885 6 54.0331 8.19348 13.7645 20.1265 23.4755 -3.20859 -6886 4 54.5379 7.42769 14.0195 10.1236 -9.46733 3.3174 -6887 4 53.1635 7.89609 13.5919 -33.2862 -9.18344 -4.84573 -6888 6 15.685 25.3343 10.6639 3.77823 -5.01457 0.699023 -6889 4 15.2925 25.3549 9.7704 -6.94194 -0.507815 8.78718 -6890 4 14.9859 25.2981 11.3464 3.26271 -0.250944 -15.837 -6891 6 18.6044 3.42728 21.9359 54.0117 -4.17358 13.1129 -6892 4 19.6007 3.50499 22.1915 -55.8621 -1.2706 -18.0159 -6893 4 18.5414 3.70523 21.0018 -0.6471 0.781857 10.4283 -6894 6 50.8906 20.6382 18.514 19.322 19.8933 14.7131 -6895 4 50.0771 21.0514 18.1693 2.40506 3.30677 2.13188 -6896 4 51.4314 21.2881 19.0676 -26.3068 -18.4046 -20.3942 -6897 6 53.3692 20.9044 31.2861 -2.87581 -0.0590227 -4.61483 -6898 4 53.3163 20.8663 32.2507 -1.10677 -1.05899 -2.14121 -6899 4 52.4655 20.8115 30.924 8.48272 0.484508 7.85381 -6900 6 52.8175 27.637 28.9992 -34.1073 -16.3293 -5.23745 -6901 4 52.1753 27.4604 29.7292 18.9476 13.4611 -8.14668 -6902 4 53.5412 28.184 29.256 17.7352 16.912 19.7012 -6903 6 33.3098 15.691 11.3293 10.3241 5.44869 29.2776 -6904 4 33.5439 15.9761 12.2647 -8.49351 -12.0766 -30.078 -6905 4 32.4682 16.1118 11.1139 -1.38634 1.49203 3.14806 -6906 6 20.3823 26.792 27.4754 10.6616 14.7237 17.2289 -6907 4 19.6846 27.4135 27.2507 -4.69437 -0.849554 -6.03625 -6908 4 20.895 27.2908 28.1563 -10.3656 -18.3754 -15.2612 -6909 6 8.54404 2.05454 14.1651 1.1449 13.7122 2.29602 -6910 4 8.12946 1.19872 14.2191 -6.02545 -13.9865 0.607463 -6911 4 8.06484 2.58201 14.8308 4.74922 -3.38849 -5.44478 -6912 6 40.1105 7.56396 40.6794 -0.469697 6.72942 -1.63666 -6913 4 39.7195 8.28533 41.2425 20.0171 -18.0739 -7.27063 -6914 4 40.8018 7.03949 41.1472 -13.6242 13.5344 3.71207 -6915 6 6.897 6.83213 10.7811 7.71606 15.0782 -3.77655 -6916 4 7.19774 7.75246 10.6132 -6.74961 -17.2243 4.00207 -6917 4 7.00156 6.6927 11.7358 -2.06706 0.697676 -4.80225 -6918 6 31.2469 6.57665 20.133 15.2512 -44.8317 5.05575 -6919 4 30.6435 5.99888 20.634 -3.65198 3.16249 1.16613 -6920 4 30.7682 7.35458 19.9689 -22.0921 35.6742 -6.0398 -6921 6 54.5384 21.0446 27.3066 23.2273 -48.3206 40.5729 -6922 4 0.0992734 20.2122 27.4067 -21.2046 24.987 7.15799 -6923 4 54.6588 21.2398 26.4073 -2.82622 20.9035 -45.5707 -6924 6 4.74298 23.1434 16.2203 -30.2995 19.4891 -12.6787 -6925 4 4.36556 24.0555 16.215 7.46998 -18.526 0.357752 -6926 4 5.49124 23.2367 16.7883 23.1348 -5.45784 14.6166 -6927 6 25.5466 11.0338 14.8277 10.3359 0.700294 4.3384 -6928 4 26.1246 10.3443 15.2243 -8.70528 11.4294 -11.7317 -6929 4 25.9183 11.8873 15.0941 -0.865353 -5.34287 -3.41216 -6930 6 41.1962 41.784 29.9422 -30.017 -5.50367 -10.8152 -6931 4 40.9141 40.905 29.5845 10.5201 22.1914 8.67773 -6932 4 40.3904 0.453034 29.9085 19.4524 -11.6054 2.3136 -6933 6 52.2783 15.2862 41.6211 7.07203 -4.19206 -10.8941 -6934 4 51.9431 15.9476 0.307056 -1.67854 11.1856 8.97788 -6935 4 51.5699 14.6487 41.5543 -8.05659 -11.9472 -4.98288 -6936 6 37.758 21.7866 37.8526 10.4754 12.291 4.40187 -6937 4 37.8833 20.8525 37.7239 2.64231 -18.5298 -3.43162 -6938 4 38.1062 21.9123 38.7409 -0.189838 4.59809 2.45253 -6939 6 23.846 9.72877 27.5599 -20.0483 -53.0743 -18.3837 -6940 4 23.7508 8.9538 26.878 9.78252 41.145 35.6193 -6941 4 23.2758 9.50619 28.3397 9.82275 7.24107 -18.911 -6942 6 43.0179 28.0371 32.8168 -8.27592 12.0689 -0.875134 -6943 4 42.8326 27.1827 33.2413 14.9994 1.75302 -2.99965 -6944 4 43.9358 28.1723 32.5349 -8.32605 -13.2452 6.20231 -6945 6 34.1493 21.223 11.895 -6.4617 -26.4803 6.62596 -6946 4 33.7114 20.3967 12.2433 5.74917 23.5867 -12.2191 -6947 4 33.6625 21.5015 11.0997 -1.34318 -2.64619 5.02085 -6948 6 10.5048 31.8203 10.0934 3.12763 27.8567 -5.97475 -6949 4 10.8893 32.6663 10.3856 -2.25958 -16.5293 2.97323 -6950 4 10.042 32.0955 9.27903 1.62317 -10.8132 6.61598 -6951 6 35.8582 37.1311 22.1219 17.442 6.8165 -15.3109 -6952 4 36.7754 37.4644 22.0121 -13.2022 -8.29883 -6.66499 -6953 4 35.6795 37.2674 23.0383 -11.5038 0.0185045 25.2366 -6954 6 27.2889 4.59659 27.4585 -59.4895 -12.2555 32.2126 -6955 4 27.8503 4.63259 28.2407 7.94553 1.46958 -1.61102 -6956 4 26.3513 4.38137 27.8533 49.6255 8.2673 -26.6042 -6957 6 39.0071 22.2889 10.6559 -18.7539 6.55471 8.53947 -6958 4 39.6145 22.0219 9.97399 11.0637 -4.63202 -10.5583 -6959 4 38.132 22.2267 10.2407 1.98377 -6.13574 3.6668 -6960 6 30.7475 39.195 10.9378 13.4076 -25.4475 -2.13886 -6961 4 31.7135 39.1987 10.9202 1.84768 25.2682 1.10777 -6962 4 30.6542 38.2342 10.8274 -15.9936 9.0572 -1.5893 -6963 6 44.6038 26.9469 2.19596 -3.02312 -2.7981 0.496435 -6964 4 44.789 26.0668 2.58199 4.34993 15.1048 -14.5643 -6965 4 45.3477 27.2287 1.63769 1.54159 -5.20589 8.29494 -6966 6 23.7761 14.5574 26.4892 -1.60295 28.5342 -20.4107 -6967 4 23.6176 15.1119 25.659 4.49284 -25.3407 28.839 -6968 4 23.2395 13.7622 26.4238 -2.18231 -2.53609 -2.40557 -6969 6 38.3444 13.3746 39.6516 36.4054 -1.80378 3.51049 -6970 4 39.1202 13.8805 40.0461 -33.1028 -11.4882 -12.1373 -6971 4 37.5326 13.855 39.8351 -2.35218 5.60767 6.28087 -6972 6 17.8972 17.2344 29.4073 9.50877 -9.96512 10.1834 -6973 4 17.6974 16.8197 28.5593 -3.90288 0.722299 -3.3346 -6974 4 17.259 17.9348 29.5179 -13.7448 8.39178 0.729907 -6975 6 17.4263 29.84 9.91085 4.63967 13.4244 18.4952 -6976 4 16.5241 29.7155 9.63978 -6.68442 -7.79832 -10.641 -6977 4 18.0121 29.6473 9.18714 6.17675 -5.88453 -9.84082 -6978 6 35.6257 6.05657 19.614 -2.53427 -7.67526 1.74575 -6979 4 35.1442 5.56448 18.9178 7.07991 15.7277 0.668344 -6980 4 35.8526 6.94177 19.2847 -2.44106 -6.98166 -5.33042 -6981 6 18.6731 22.2952 17.5195 -8.35574 4.99894 -0.254983 -6982 4 17.7298 22.4259 17.6349 -7.1371 0.699885 10.6378 -6983 4 18.7532 22.3981 16.578 9.97204 2.32932 -16.3296 -6984 6 20.0126 3.82895 32.2846 -5.38506 7.6032 10.998 -6985 4 19.7316 4.05659 31.3951 3.95105 0.959407 -6.40709 -6986 4 20.9087 3.45699 32.2166 -3.62371 1.18893 -2.87546 -6987 6 5.48106 6.97474 8.11911 -13.3431 -28.5569 -4.23146 -6988 4 5.76723 7.87539 8.05126 9.5873 19.9723 5.64469 -6989 4 5.84003 6.56862 8.91875 4.365 4.20298 7.41399 -6990 6 44.2055 20.527 25.594 -36.5422 -32.7496 -22.1294 -6991 4 44.4952 21.1964 26.2048 27.2712 12.1663 0.509182 -6992 4 44.8136 20.1687 24.9192 13.264 16.717 13.5958 -6993 6 43.9676 36.9898 17.8707 9.43563 13.9581 11.3899 -6994 4 44.6425 37.4866 17.3506 -13.9886 -14.2814 1.04264 -6995 4 43.5166 36.316 17.3518 1.57776 -4.71986 -9.07493 -6996 6 34.624 10.1249 16.2553 -3.80507 -0.870494 -23.8528 -6997 4 34.4029 10.0232 15.2766 7.60873 7.05542 33.3523 -6998 4 34.6485 11.0843 16.4397 0.136369 -4.79707 -6.11079 -6999 6 23.6588 3.43472 1.31587 2.0947 2.20184 -10.1691 -7000 4 23.5283 2.45383 1.23665 3.68597 29.2686 -10.0862 -7001 4 23.7829 3.95594 0.465507 -5.48879 -27.0668 21.3429 -7002 6 33.408 38.9514 5.0951 12.9752 29.4037 8.61745 -7003 4 33.0296 38.079 4.95882 -18.4714 -2.71742 3.9597 -7004 4 32.7559 39.6696 5.33685 4.56028 -29.4715 -9.24259 -7005 6 22.5612 32.5054 35.7914 -7.59797 17.3543 -6.08959 -7006 4 23.434 32.1498 35.9581 8.59623 -0.183209 1.98348 -7007 4 22.6598 33.4814 35.6698 2.01652 -18.126 2.22848 -7008 6 32.4197 37.2669 13.8205 20.7322 22.1346 -9.91782 -7009 4 31.6112 36.8955 13.5272 -29.3682 -10.7083 -8.61391 -7010 4 32.7793 36.5983 14.3861 8.71878 -17.2052 10.8721 -7011 6 52.6061 12.7509 39.5955 -8.08982 -5.36768 -0.728302 -7012 4 53.2357 13.3696 39.2333 6.80499 9.05338 -6.44134 -7013 4 53.0752 12.2813 40.2869 4.34006 -2.9945 3.85342 -7014 6 28.8406 14.5639 1.22393 13.2702 13.2594 -7.07732 -7015 4 28.2547 13.832 1.29641 -8.98786 -23.9917 -3.18497 -7016 4 28.3081 15.2705 1.57856 0.691728 8.20301 3.76967 -7017 6 1.46371 32.4171 23.3808 -12.1734 -25.5645 13.9938 -7018 4 1.52421 31.5049 23.0145 7.51613 19.861 -1.66683 -7019 4 1.90409 33.05 22.8306 10.4998 5.06095 -20.3958 -7020 6 54.3326 23.3294 28.9734 2.61182 15.3833 -1.51239 -7021 4 54.2696 22.9227 29.8387 -0.130455 -4.55084 5.05008 -7022 4 54.4476 22.6226 28.3359 -0.0534198 -9.82677 -0.516761 -7023 6 14.3165 12.143 35.6759 -19.2415 -8.81627 -0.503167 -7024 4 14.3877 12.7977 36.3527 0.233596 18.6669 11.2481 -7025 4 15.2077 11.8775 35.5438 25.0768 -7.98239 -7.51161 -7026 6 18.9926 6.51479 41.2701 -28.9824 -29.6237 1.81046 -7027 4 18.266 5.84223 41.3522 13.7729 17.3268 -5.20094 -7028 4 19.3309 6.57432 0.258232 8.64619 7.1183 4.95474 -7029 6 5.3156 17.8978 20.3375 -21.1545 16.5991 3.60383 -7030 4 4.72623 18.3448 19.6879 4.29754 -5.05212 8.41069 -7031 4 4.82948 17.9368 21.1935 9.1049 1.98802 -15.8618 -7032 6 24.7216 34.9676 30.1666 -3.07326 -14.2394 -14.8574 -7033 4 24.8542 35.9126 30.1802 4.14387 12.0412 4.3338 -7034 4 24.7023 34.7085 29.2239 -0.0690866 8.67132 12.606 -7035 6 31.8759 4.61762 18.1838 16.2734 -6.94643 -1.61547 -7036 4 31.7767 5.32612 18.8146 -0.693712 9.66586 8.6442 -7037 4 30.9961 4.53608 17.8264 -12.7431 -2.99311 -6.3499 -7038 6 8.70679 17.4876 5.93376 -7.2594 15.0659 3.57914 -7039 4 7.94553 18.1226 5.84491 19.4684 -9.25267 2.2845 -7040 4 9.55198 17.9922 5.98984 -15.4384 -2.82622 -0.0668602 -7041 6 29.8338 10.9771 14.4736 2.85583 -20.8689 4.17621 -7042 4 29.3487 11.4359 13.7779 -2.35633 12.0716 2.99849 -7043 4 29.9333 11.5067 15.2792 -5.11986 9.15119 -1.36774 -7044 6 48.7176 10.2992 32.5766 37.752 -4.2965 -7.5649 -7045 4 48.6861 9.98692 33.5109 4.36425 8.41374 -15.5521 -7046 4 49.6689 10.1741 32.2115 -43.6207 3.75412 17.6406 -7047 6 8.33261 15.6868 37.8739 25.2856 -16.7599 -34.932 -7048 4 8.10095 16.0156 38.719 -17.2941 17.7495 29.2541 -7049 4 7.84865 16.1686 37.1872 -4.77393 6.83012 10.4818 -7050 6 50.4 3.07893 17.326 6.75193 2.54677 -10.5223 -7051 4 49.8476 3.08454 16.5614 0.0537611 0.514048 -24.7797 -7052 4 49.7563 3.22783 17.9993 -5.52918 6.4504 35.6689 -7053 6 14.6925 38.3995 10.8943 -10.4545 -11.2686 -1.07851 -7054 4 14.3539 38.6226 11.7634 0.533319 14.8424 10.3104 -7055 4 14.2274 37.5681 10.7419 5.82896 -0.087222 -8.72758 -7056 6 34.1157 6.37736 10.827 20.4112 17.5403 9.63945 -7057 4 34.1356 7.15575 10.2337 -4.79421 -13.4894 2.09643 -7058 4 34.9392 6.47467 11.3721 -17.4677 -2.57189 -8.67394 -7059 6 7.16428 37.5549 17.6272 35.8206 -6.94283 1.42456 -7060 4 8.17672 37.4379 17.5039 -45.4701 3.04153 9.54579 -7061 4 6.9329 37.0909 18.4673 4.48983 7.2965 -12.9876 -7062 6 51.5173 11.3068 16.7982 -29.6345 12.4732 -19.9425 -7063 4 52.2329 10.8476 17.1999 24.0623 -16.8016 7.00331 -7064 4 51.4947 11.1437 15.8343 5.46468 -1.37513 9.57578 -7065 6 15.6604 8.64432 3.1895 3.55656 -13.2601 -18.336 -7066 4 15.3831 9.26805 3.84437 -11.3932 20.6181 15.5674 -7067 4 16.2117 8.03967 3.68493 6.317 -8.49687 -0.892024 -7068 6 5.4241 21.4549 11.925 7.11554 10.6798 -7.02681 -7069 4 5.33432 22.3429 11.4717 -4.65036 -17.889 17.4658 -7070 4 4.77116 21.2815 12.6313 -0.367847 15.68 -7.67111 -7071 6 50.1893 24.0442 37.9781 -13.1484 0.855785 -17.0816 -7072 4 49.5179 24.1845 37.2801 8.13829 0.111989 16.6227 -7073 4 50.739 23.3224 37.6715 2.2014 -1.01472 3.1635 -7074 6 39.7382 11.2507 31.6977 23.6406 7.23187 -3.58891 -7075 4 40.4046 11.8538 31.2923 -18.8268 -10.2166 5.80002 -7076 4 38.8713 11.6238 31.5229 -1.54541 8.70996 -4.13134 -7077 6 26.6923 10.8294 20.5841 1.50171 17.3672 -0.163562 -7078 4 26.3063 11.3901 21.299 5.00814 -17.7696 -11.6362 -7079 4 26.5519 9.91114 20.8376 -1.99146 -0.979444 5.82041 -7080 6 12.5744 17.5779 18.1705 9.62673 -31.396 -11.9521 -7081 4 12.2909 16.663 17.987 19.11 1.74385 -8.92353 -7082 4 11.8345 17.8227 18.6757 -30.0259 29.7826 25.4081 -7083 6 47.7778 31.6094 17.3292 -7.10666 -17.038 -8.06235 -7084 4 48.347 31.2547 18.014 2.28217 1.30733 4.94459 -7085 4 47.3418 30.8212 16.9416 1.10301 17.3121 -1.07651 -7086 6 1.06524 3.39018 18.5298 -14.3894 10.3619 10.5476 -7087 4 1.40487 3.81402 19.3241 14.4239 4.64695 -0.395869 -7088 4 0.13491 3.28998 18.7837 -2.56119 -4.67364 -10.5163 -7089 6 26.5953 20.387 15.3121 4.86749 -24.5982 -5.101 -7090 4 27.0693 19.5476 15.0746 -6.18915 17.8108 6.48343 -7091 4 25.6882 20.059 15.4501 7.15985 4.40883 -1.86988 -7092 6 42.0068 3.03472 36.7639 -8.02624 -14.3838 3.82934 -7093 4 41.5138 2.21919 36.6422 -1.8797 -9.24856 -19.1073 -7094 4 41.9017 3.12445 37.6992 6.42334 14.3979 20.8626 -7095 6 39.3283 22.4329 33.1866 16.7976 22.9312 16.1168 -7096 4 39.617 22.6043 34.1233 -9.1007 -15.4059 -24.4851 -7097 4 39.2996 23.351 32.8579 -1.9326 -13.3537 -7.72798 -7098 6 18.5014 34.9723 11.9503 -40.872 8.93582 -22.0032 -7099 4 19.313 34.895 12.3871 37.9781 -3.12322 33.9295 -7100 4 17.8134 35.1232 12.6133 -0.0311416 1.40314 8.7121 -7101 6 22.862 14.1089 0.203393 17.2545 -2.37957 19.5806 -7102 4 23.1276 14.8054 41.5255 0.219481 9.03583 -13.3452 -7103 4 23.4003 14.3117 0.999915 -8.23864 -6.67581 -7.59618 -7104 6 30.9898 16.6325 33.7811 -26.24 4.82889 -18.7278 -7105 4 30.4991 16.9295 32.9906 -1.06726 -7.21679 15.5744 -7106 4 31.8724 16.8786 33.545 20.2345 1.84197 6.64809 -7107 6 28.4142 35.5086 5.55132 5.25795 11.5001 -0.86936 -7108 4 29.133 34.8901 5.6729 7.87573 -11.0207 0.32142 -7109 4 28.8444 36.3678 5.44284 -5.96253 -1.38672 0.306744 -7110 6 2.06178 31.4487 10.6522 7.7724 2.5252 5.43788 -7111 4 2.46787 32.1741 10.1582 1.48866 -1.05725 0.00513454 -7112 4 1.12423 31.5492 10.4902 -10.7705 -1.69396 -4.48797 -7113 6 5.96168 9.75465 21.3469 -3.89643 8.81348 -50.5901 -7114 4 6.28958 10.5041 20.7544 -9.04712 -29.7196 22.9081 -7115 4 5.37557 9.21645 20.7377 15.5825 17.9805 22.1648 -7116 6 24.7784 26.6095 2.66066 11.1746 -2.24162 5.28408 -7117 4 23.9956 26.7754 2.10108 -2.29597 -10.0774 9.56872 -7118 4 24.6953 25.8682 3.30791 -10.2989 11.7132 -14.8816 -7119 6 45.7373 4.24983 18.6143 27.3178 -0.763462 -4.2154 -7120 4 46.5067 4.85242 18.4954 -19.0177 -2.03966 3.70694 -7121 4 46.1538 3.38182 18.4484 -14.6954 3.88493 3.6473 -7122 6 4.46307 0.776675 15.9004 -0.0751459 19.7124 -7.24544 -7123 4 4.28648 41.7452 15.8506 7.90268 -11.6504 4.49907 -7124 4 5.34722 0.941656 16.2766 -7.84 -9.44871 -1.18019 -7125 6 2.43543 19.4835 25.3975 -8.02289 7.34849 22.5637 -7126 4 1.8039 19.0427 26.0095 9.34608 -2.48106 -16.7091 -7127 4 2.63666 18.9452 24.6346 -2.8512 -10.1259 -3.82486 -7128 6 40.5893 8.48301 5.11314 -1.35782 -12.8068 -2.32465 -7129 4 40.7524 9.27543 5.61119 -3.30667 17.7402 10.4879 -7130 4 41.4486 8.05286 5.16027 3.34022 -8.8045 -8.92488 -7131 6 49.3107 22.3512 41.5276 -10.6582 56.3201 6.76971 -7132 4 48.577 22.7852 41.0387 15.264 -8.60422 5.01334 -7133 4 49.2575 21.458 41.2835 -0.448838 -46.7272 -11.6484 -7134 6 0.358901 40.9209 20.5803 -19.8443 -5.20423 -21.0143 -7135 4 0.209912 39.9476 20.5616 0.00996972 10.506 -0.843682 -7136 4 54.6254 41.351 20.0384 15.1519 -13.0167 14.2251 -7137 6 34.868 15.3449 38.0159 -4.77394 11.9701 -21.6163 -7138 4 34.21 16.0699 37.905 14.1938 -11.5268 -7.28032 -7139 4 35.478 15.4115 37.2329 -18.0572 6.07255 16.3223 -7140 6 7.76403 26.0071 29.8556 5.34791 -0.957035 4.21351 -7141 4 8.62364 26.4528 30.0224 -8.82329 -12.5157 -0.945539 -7142 4 7.90301 25.0604 30.0866 1.23738 19.4493 -2.25897 -7143 6 40.714 22.798 20.4449 30.2403 28.6605 -20.1452 -7144 4 41.3584 23.4838 20.081 -22.4198 -29.1089 11.875 -7145 4 40.2102 23.3285 21.0558 -12.075 4.18803 12.4472 -7146 6 37.6868 25.6422 36.0641 6.66209 -5.59755 13.6904 -7147 4 38.2808 24.8923 36.0269 4.65063 -3.44496 7.57849 -7148 4 37.3429 25.6351 35.1859 -16.0941 8.70932 -25.1352 -7149 6 5.45062 23.9828 10.2587 5.16865 5.9624 5.01697 -7150 4 5.97911 23.8188 9.45867 -6.21725 4.51436 8.29683 -7151 4 5.82702 24.8173 10.6422 -10.2102 -24.7042 -13.9856 -7152 6 48.3972 21.0585 38.1887 36.079 14.8531 -15.9941 -7153 4 48.9083 20.6932 38.9203 -9.15007 -3.24726 4.47194 -7154 4 49.1186 21.3212 37.5505 -33.8036 -6.43701 14.9947 -7155 6 15.2894 25.0118 3.53737 -15.5341 -16.8072 10.9824 -7156 4 15.3523 24.0463 3.54635 7.80908 -0.218079 -10.1213 -7157 4 14.6524 25.152 4.25109 -0.971191 12.1275 -1.41446 -7158 6 46.3973 40.2818 20.0864 -5.10979 -28.8528 0.810189 -7159 4 46.7099 39.3289 20.1836 -4.69047 35.7762 -3.66479 -7160 4 47.1343 40.8792 20.2285 11.4236 3.93541 -0.385178 -7161 6 34.6613 36.4755 0.335066 -24.7851 30.4749 -21.6933 -7162 4 34.8743 36.0541 1.15687 -4.43901 -4.57192 24.0914 -7163 4 33.7851 36.9546 0.454416 30.1492 -20.7825 2.99091 -7164 6 52.5881 7.99834 30.4195 9.51271 -12.4348 0.483116 -7165 4 52.1042 8.76616 30.7719 -8.49213 -7.21741 -10.9068 -7166 4 52.0722 7.46347 29.7764 0.520668 12.6171 10.1624 -7167 6 32.0714 3.86484 29.4697 -9.7538 -17.9077 -31.6249 -7168 4 31.6702 2.97314 29.6052 7.93851 20.6113 2.31556 -7169 4 32.0839 3.94733 28.4741 0.539668 -3.17995 32.4864 -7170 6 20.3786 17.8365 28.6466 -12.59 16.0252 -12.2548 -7171 4 19.5397 17.5939 29.0718 10.0495 1.57584 1.91854 -7172 4 20.0545 18.3008 27.843 10.529 -6.18443 10.1885 -7173 6 30.4085 41.1704 41.0135 6.18506 -3.22706 -14.2809 -7174 4 30.53 40.7341 40.1581 -10.3332 2.11637 -0.589059 -7175 4 31.2241 40.9477 41.4498 10.7912 2.88832 12.9661 -7176 6 35.4567 32.8541 27.9296 20.1033 20.3116 -25.2142 -7177 4 35.1103 33.2872 28.7174 -1.27312 4.66796 4.01126 -7178 4 35.9087 33.5476 27.342 -15.0191 -24.2746 21.4934 -7179 6 14.3794 6.67806 12.7301 -1.9413 28.2373 -4.00169 -7180 4 15.2373 6.26429 12.8613 2.01848 -2.11516 -0.858514 -7181 4 14.5332 7.65903 12.7289 -3.54891 -27.4927 -2.87641 -7182 6 41.884 41.5441 20.3292 17.5267 3.97767 -7.39307 -7183 4 42.6467 41.3531 19.7473 -6.80228 5.43899 6.41045 -7184 4 41.2989 40.8038 20.1922 -8.54368 -4.96293 -3.75352 -7185 6 46.4016 22.5784 8.86191 7.75251 -10.6521 7.11129 -7186 4 45.8476 21.8716 8.52158 -12.3576 2.35246 -8.51817 -7187 4 47.0146 22.0703 9.39636 1.75986 6.35736 5.22437 -7188 6 17.4049 20.6472 13.8946 9.03444 14.2526 1.49725 -7189 4 17.6929 21.5842 14.0543 -8.3446 -25.4959 -7.46489 -7190 4 17.3265 20.4984 12.9333 2.034 6.01629 5.63707 -7191 6 8.18883 9.49722 13.352 -36.2403 7.79383 -0.838203 -7192 4 7.38606 10.0563 13.5919 32.9103 -12.129 -3.09847 -7193 4 9.02271 9.90793 13.6245 -5.40631 9.4956 5.41337 -7194 6 7.5857 14.8045 29.5864 0.660595 8.18183 -2.22865 -7195 4 7.08502 14.4366 30.3218 -1.52277 2.83209 3.37304 -7196 4 7.02502 15.474 29.1565 2.15616 -5.78955 1.98978 -7197 6 29.5787 39.2199 22.642 -23.9064 2.77655 4.40715 -7198 4 29.7923 38.7231 23.4359 12.3113 -5.95711 5.92816 -7199 4 30.3289 39.2945 22.0576 16.6647 -3.01011 -3.30282 -7200 6 19.7261 28.8048 8.43629 7.07867 10.1416 -1.30332 -7201 4 19.5094 27.8711 8.56662 5.24428 2.50367 -2.7317 -7202 4 20.6808 28.8901 8.64157 -12.3267 -4.04756 -0.658665 -7203 6 20.0918 21.6433 25.9098 -22.8378 18.9737 -2.62589 -7204 4 20.6828 21.9331 26.6394 -14.5657 0.991195 -11.6344 -7205 4 19.2872 22.2354 25.9429 24.6623 -16.2361 5.64257 -7206 6 12.7798 16.1171 22.7918 2.83481 -1.66518 -8.4999 -7207 4 12.1052 16.761 22.5802 -5.26913 11.1277 0.000470885 -7208 4 12.4145 15.3113 22.3987 5.67676 1.62415 3.74644 -7209 6 7.09341 27.2127 17.9852 -17.6727 17.6357 -2.43489 -7210 4 7.71878 26.5086 17.8851 15.5779 -18.3258 -2.50971 -7211 4 7.24623 27.7931 17.2297 2.82114 0.873921 -0.89624 -7212 6 32.4121 8.69011 34.8574 -11.3856 31.068 25.9423 -7213 4 32.686 9.10208 35.716 -2.62469 -14.8204 -24.695 -7214 4 31.4981 9.04705 34.7249 20.8054 -13.4625 -4.53694 -7215 6 50.3489 28.2274 17.5408 2.96892 -19.9668 3.87059 -7216 4 50.2931 27.3328 17.9381 -3.71715 13.2344 -0.552608 -7217 4 51.012 28.0828 16.8476 -2.81747 8.99858 -3.49204 -7218 6 15.6752 32.1523 25.7996 -24.1097 -1.02752 -8.0065 -7219 4 16.4469 32.5721 26.1513 19.1192 7.47953 7.03048 -7220 4 15.1241 32.8942 25.4834 5.39501 -5.59697 3.80799 -7221 6 41.2942 22.0009 29.6469 23.8016 -11.3242 12.4312 -7222 4 40.6197 22.5451 29.2897 -20.6362 19.5621 -14.8771 -7223 4 40.8321 21.2604 30.0334 -1.27155 -6.80964 4.85239 -7224 6 24.5512 12.7478 8.87624 0.539479 -2.56763 -16.1827 -7225 4 24.2317 13.5544 9.29419 1.48927 0.294937 0.678301 -7226 4 24.2485 12.8104 7.9491 4.47413 -5.17195 11.4459 -7227 6 47.3043 20.1171 10.4067 20.0451 13.2477 8.4905 -7228 4 48.2327 20.3756 10.3708 -0.951507 4.56311 9.88278 -7229 4 47.2371 19.5522 9.64912 -14.6685 -17.4861 -17.2657 -7230 6 17.6686 14.2187 29.9453 7.31834 -6.07886 -8.28437 -7231 4 16.8567 14.6777 30.1627 -12.3548 11.6861 -0.426412 -7232 4 18.1621 14.7508 29.3045 -6.68566 0.573373 4.02912 -7233 6 21.3468 34.5864 28.5404 1.3464 21.7174 -7.002 -7234 4 21.5866 35.4807 28.2285 -6.04705 -7.23946 1.73439 -7235 4 21.8012 34.5133 29.372 6.90897 -8.71765 12.9147 -7236 6 35.0919 4.05058 4.01374 -15.5825 9.30565 11.5721 -7237 4 34.2387 3.74233 4.43927 22.4566 16.9059 -11.4445 -7238 4 35.1406 5.04582 3.93988 -11.3656 -25.7387 7.52347 -7239 6 29.9083 8.58745 22.5962 -15.8002 1.46007 -28.7439 -7240 4 29.4293 8.33193 21.7391 23.5037 3.33824 36.5279 -7241 4 30.4512 7.83881 22.8901 -6.5033 3.48596 -7.29863 -7242 6 9.80484 32.9578 15.933 -3.40746 -8.77641 -12.0557 -7243 4 9.78146 31.9986 16.1651 13.0086 23.7442 4.23133 -7244 4 10.4547 33.4728 16.4465 2.19651 -19.1398 5.78046 -7245 6 24.9207 14.2283 32.5839 15.8568 -2.03515 22.8032 -7246 4 25.4679 14.491 33.3602 -10.7028 -6.65113 -14.6818 -7247 4 24.5651 15.0495 32.2637 -5.99659 7.67207 -7.30645 -7248 6 49.6599 21.9679 26.2292 42.3899 27.0609 3.31449 -7249 4 50.4576 21.5325 26.6526 -24.3124 13.7703 -9.69582 -7250 4 49.9726 22.89 25.9802 -16.6307 -33.6109 8.97028 -7251 6 39.2146 29.6271 28.776 1.2649 -6.72815 -4.66326 -7252 4 39.3113 29.0399 29.5368 -1.10705 1.67847 4.24024 -7253 4 39.5646 29.0864 28.052 -0.275695 2.9096 0.748968 -7254 6 50.692 34.7829 39.7485 29.9384 -8.83369 -9.14761 -7255 4 51.6379 34.6172 39.5245 -10.9597 10.0847 13.0799 -7256 4 50.284 34.1892 39.1195 -14.598 -6.88033 -5.74908 -7257 6 29.205 20.8761 19.5187 12.6622 -8.88768 18.517 -7258 4 30.1458 21.1462 19.5468 -10.0278 2.51211 -7.13483 -7259 4 28.7621 21.2804 18.7794 -5.02457 12.868 -15.5739 -7260 6 45.8413 1.41619 21.3894 -25.1775 13.0352 -19.0829 -7261 4 45.002 1.0285 21.6935 10.996 -3.183 3.42833 -7262 4 46.5512 0.981978 21.8333 16.3199 -17.0363 14.4799 -7263 6 26.0942 5.84138 12.9755 -8.81801 -1.79204 -2.94978 -7264 4 26.5644 5.00851 12.8396 1.48472 -6.22175 2.21387 -7265 4 25.1658 5.65249 12.7519 4.56693 -2.33816 -1.27821 -7266 6 9.00853 19.0479 23.7214 20.279 18.3012 -13.9253 -7267 4 8.07192 18.8993 23.8406 -12.3386 2.44029 -0.494901 -7268 4 9.09287 19.8709 23.17 -6.05991 -16.4473 11.9144 -7269 6 47.699 14.1778 40.0244 8.37408 5.46764 -8.11648 -7270 4 48.526 14.369 39.5365 -13.6583 -0.0280305 9.55934 -7271 4 47.2742 15.0291 40.2237 1.48315 -6.20176 -4.56159 -7272 6 47.9891 19.7944 0.501942 -52.5058 -34.5194 5.9677 -7273 4 48.5389 19.8149 1.25758 31.4646 9.24384 22.8657 -7274 4 47.3233 19.1101 0.79406 16.1078 24.936 -21.6052 -7275 6 27.1644 39.5895 31.4222 -35.4984 -42.2857 -13.2745 -7276 4 26.8828 40.2644 32.0188 2.45392 19.408 13.0965 -7277 4 26.334 39.0158 31.3353 32.2444 14.87 -2.1562 -7278 6 20.718 15.281 27.2921 -20.5288 29.0824 -25.1338 -7279 4 19.7916 15.5288 27.1303 0.0426049 -12.6319 11.5337 -7280 4 21.1251 16.0883 26.9354 13.4588 -8.377 2.43969 -7281 6 53.2931 3.12982 19.6939 21.059 35.3193 6.93312 -7282 4 52.5111 3.68486 19.642 -0.600406 9.66435 -1.15328 -7283 4 52.9649 2.26115 19.6482 -6.97037 -43.0252 -2.92507 -7284 6 40.7577 33.3874 24.037 12.7176 -1.25655 15.6318 -7285 4 41.575 33.1492 24.5319 -10.6485 3.51614 -11.0419 -7286 4 40.1417 32.64 24.1417 6.01104 2.31945 0.566227 -7287 6 50.2034 37.8915 21.3784 34.5696 42.4783 -9.46203 -7288 4 50.977 37.3667 21.5595 20.6596 -6.9612 4.63629 -7289 4 49.5128 37.3071 21.51 -51.1752 -39.6198 7.18684 -7290 6 41.3315 2.34663 21.9881 -5.34027 -0.787955 22.4754 -7291 4 41.3778 2.5308 21.0564 -4.51788 5.59338 -11.8441 -7292 4 40.4369 2.61524 22.307 16.348 -5.18373 -12.1741 -7293 6 3.68887 21.2797 14.3363 -13.7249 24.7693 -29.296 -7294 4 4.1389 21.9084 14.895 6.09004 12.6164 9.74183 -7295 4 3.85532 20.4521 14.7268 10.1618 -35.5887 19.7816 -7296 6 34.2749 11.1621 36.6211 6.86722 -26.3475 -8.98455 -7297 4 34.1457 10.3739 37.2084 1.76529 18.7936 -6.49638 -7298 4 34.0208 11.9523 37.0887 -10.0392 4.20616 19.2695 -7299 6 24.047 21.9251 23.4534 9.96695 -9.01801 9.45846 -7300 4 24.1056 21.4984 22.592 0.489969 -1.19981 -5.95122 -7301 4 24.6049 21.3417 24.0221 -10.3198 12.7259 -7.25629 -7302 6 18.8859 0.355593 4.41703 6.91373 -0.488994 13.8226 -7303 4 18.8848 41.346 4.15992 -3.4937 -3.21088 -8.69706 -7304 4 19.4141 0.350836 5.23016 -4.89519 7.76131 -7.17368 -7305 6 1.61894 7.82812 17.7388 11.0013 -2.20401 0.0755565 -7306 4 1.69825 6.91132 17.4299 0.598176 5.44338 0.144381 -7307 4 0.751076 7.92867 18.1276 -6.88769 -1.80246 0.772288 -7308 6 9.88357 31.5477 26.4865 20.7425 -47.9078 -25.9665 -7309 4 9.77347 30.8406 25.7562 4.13802 32.2768 29.9214 -7310 4 9.16637 32.1481 26.416 -28.5637 22.827 -5.6847 -7311 6 46.9801 33.0031 20.3665 8.92807 -2.6835 25.0439 -7312 4 47.1906 32.5959 21.2783 -12.5238 7.50902 -41.0074 -7313 4 46.473 32.3868 19.8049 3.08737 -2.68707 12.6131 -7314 6 49.5381 29.29 21.3848 5.35466 4.48298 6.61079 -7315 4 50.3596 28.8237 21.4263 11.6576 -22.6485 -14.6982 -7316 4 49.6544 29.7814 22.1942 -19.8316 15.0268 8.13943 -7317 6 13.5135 31.8933 19.1567 20.4477 19.0535 18.7588 -7318 4 12.9544 32.0303 19.9484 11.7182 -3.51681 -10.2564 -7319 4 14.3688 32.3555 19.4049 -26.6747 -15.4769 -10.5401 -7320 6 46.6242 34.0973 16.9259 3.25439 -22.1556 18.333 -7321 4 46.8986 34.1178 16.0034 3.18051 -0.659651 -5.23437 -7322 4 46.9878 33.2447 17.2966 -6.98741 23.2488 -14.973 -7323 6 19.7685 39.5238 2.42723 -1.93992 9.56528 -9.07466 -7324 4 20.504 40.1421 2.55739 -2.20075 -2.41675 -0.557551 -7325 4 19.2228 39.9982 1.75695 7.86662 -14.3322 13.7479 -7326 6 16.5372 9.39399 28.3106 5.81076 4.55242 0.698497 -7327 4 16.5228 10.3583 28.3138 -6.10914 3.2393 2.1867 -7328 4 17.4567 9.2086 28.1181 8.68803 -11.6531 -1.09187 -7329 6 3.04764 33.3834 8.9498 9.15555 8.47462 14.2626 -7330 4 2.34782 34.0603 8.86882 1.18173 -6.7492 -12.1187 -7331 4 3.16543 32.8691 8.13996 -9.91006 6.39371 -6.60301 -7332 6 49.6799 28.314 0.198287 -24.1009 9.02482 3.02524 -7333 4 50.5864 28.3416 41.8577 25.8797 -1.22492 -6.2647 -7334 4 49.539 27.5375 0.746128 -0.431885 -1.84115 5.43874 -7335 6 1.41501 6.84656 30.491 -4.80497 13.9866 22.936 -7336 4 1.80101 7.66454 30.873 3.64878 -10.2221 -13.1962 -7337 4 0.770406 6.61566 31.1883 9.6026 -0.286793 -13.8716 -7338 6 19.7721 9.41455 33.714 -8.86768 10.4812 -29.5452 -7339 4 19.9336 8.45599 33.7164 -2.74186 3.51224 -8.50186 -7340 4 19.4649 9.70036 32.7878 8.54711 -12.9815 34.2723 -7341 6 26.1689 11.9219 3.60877 17.3014 14.1658 -18.8808 -7342 4 25.6285 12.278 4.29668 -11.0155 5.7348 17.6305 -7343 4 26.0891 10.974 3.64129 -4.70103 -13.8965 4.54114 -7344 6 33.2526 2.15457 18.2061 -11.4346 36.8522 -3.73875 -7345 4 32.7853 2.99777 18.4754 10.6797 -23.9754 -11.6278 -7346 4 32.6748 1.45157 18.4903 -6.58847 -5.37306 4.71859 -7347 6 1.56641 29.1164 15.6218 -13.5802 38.9916 52.9136 -7348 4 0.75332 28.6899 15.9164 -2.28927 1.65734 -1.12046 -7349 4 1.88381 28.6368 14.9104 18.6776 -39.2188 -53.7174 -7350 6 41.7212 4.09992 39.5909 -11.2791 25.9615 -27.213 -7351 4 41.4168 4.81457 38.9155 6.653 -41.6332 33.8875 -7352 4 40.9635 3.53859 39.8438 1.60091 7.46224 -7.31473 -7353 6 28.6931 41.7984 21.1891 -6.68751 -8.42641 -4.80462 -7354 4 29.0735 0.780303 21.3271 9.25035 -16.558 -3.13259 -7355 4 29.3834 41.1221 21.0106 -2.7364 22.7931 4.70591 -7356 6 11.6395 12.4176 35.4525 -19.931 13.6599 -6.89173 -7357 4 11.6974 12.2316 36.3791 0.0383878 -4.43782 22.0781 -7358 4 12.5438 12.3774 35.1867 22.2579 1.64914 -11.6458 -7359 6 9.79005 12.0613 0.287125 39.0331 19.741 15.6941 -7360 4 10.6741 12.3652 0.649112 -24.288 -6.9143 -28.8601 -7361 4 9.37178 11.7496 1.07064 -16.9981 -12.0004 12.0483 -7362 6 48.1738 12.4001 9.21087 -14.7098 16.6281 -3.51107 -7363 4 48.3046 11.757 8.50338 5.36034 -5.93883 0.971929 -7364 4 48.886 12.3441 9.8545 11.7295 -7.72549 2.46367 -7365 6 20.1355 24.3829 18.9522 12.9308 -0.734849 -39.1055 -7366 4 19.4937 23.7815 18.5135 12.9255 8.80461 9.87411 -7367 4 20.8069 24.6162 18.234 -21.1698 -7.06963 26.7537 -7368 6 16.5393 31.2961 16.4761 -1.92172 -19.5246 -12.7122 -7369 4 16.66 32.2288 16.679 -4.64409 4.5232 17.4599 -7370 4 16.1207 30.7474 17.1716 1.36469 17.4989 2.94612 -7371 6 1.78169 14.6393 36.2977 19.9207 14.6923 -9.09136 -7372 4 1.03986 14.2937 35.8105 -15.9251 -7.35249 0.645581 -7373 4 1.68132 14.4688 37.2355 -8.64532 -4.94464 12.0587 -7374 6 4.36624 29.2084 29.5903 15.7403 17.1522 -11.4447 -7375 4 4.94475 28.7816 30.2313 0.42296 -3.8665 4.22363 -7376 4 4.9316 29.8996 29.1557 -19.5902 -17.4666 6.54186 -7377 6 43.6839 0.248111 22.6506 -19.7732 -13.3298 -9.50689 -7378 4 42.8764 0.661685 22.3065 0.028666 2.48852 1.60322 -7379 4 43.5183 41.2016 22.5042 11.2477 10.9397 1.57875 -7380 6 52.4994 40.9828 27.2386 -0.538127 -6.12089 -28.931 -7381 4 52.76 40.8447 26.286 -9.02638 3.90908 21.7421 -7382 4 53.2684 41.4137 27.6303 2.05735 4.02476 1.85103 -7383 6 25.5814 23.8969 27.7396 -24.7861 2.98762 0.531627 -7384 4 24.718 24.3642 27.6072 20.4038 -13.4527 4.15226 -7385 4 26.2821 24.4835 27.457 3.8963 1.45656 -1.88052 -7386 6 23.1228 17.031 33.3243 -5.52517 1.23961 5.4323 -7387 4 23.1399 17.5083 34.1558 0.441881 0.23205 -0.480567 -7388 4 22.8557 16.1383 33.5546 -4.67547 -8.64305 1.56256 -7389 6 2.92722 11.8725 21.3561 -41.4423 -19.1296 -19.7046 -7390 4 2.18606 11.2638 21.6443 29.5918 21.1066 -8.34803 -7391 4 3.54191 11.9259 22.0595 17.1072 -0.484489 21.5157 -7392 6 2.18317 4.15265 30.0257 5.779 -9.3787 -10.7468 -7393 4 2.12921 5.11001 30.0802 -2.76576 12.2821 -0.843831 -7394 4 2.67493 3.96573 29.2018 -3.29095 2.88479 4.98522 -7395 6 26.6728 30.2949 13.4768 7.17255 0.654769 14.1147 -7396 4 25.7117 30.2905 13.6467 8.22624 -2.44269 3.31295 -7397 4 27.1112 30.3188 14.3546 -11.9073 -0.623098 -17.8849 -7398 6 24.8734 30.8117 10.8292 -29.6944 -3.60301 -2.53615 -7399 4 25.2254 30.0431 10.3884 7.40196 -6.71761 -6.36825 -7400 4 25.5983 31.2424 11.2381 22.0508 11.6497 12.6203 -7401 6 53.1723 24.107 4.51212 -8.50651 -29.3458 16.902 -7402 4 53.5087 24.8189 4.00388 11.9327 21.9784 -14.7749 -7403 4 53.9335 23.6869 4.92936 2.49868 2.30602 2.88115 -7404 6 24.9006 4.49574 23.9943 -15.2803 12.8054 -1.91421 -7405 4 24.3197 5.26112 23.9044 -17.3839 -11.7779 6.16284 -7406 4 25.6928 4.95696 23.7819 42.3091 -2.82475 -3.31223 -7407 6 34.6808 1.64534 41.2582 -1.16689 -16.4189 -19.1193 -7408 4 35.6107 1.42238 41.0689 -7.35569 3.11738 8.02352 -7409 4 34.6894 2.06091 0.199506 5.11707 10.3461 19.9542 -7410 6 13.3318 19.5273 16.3875 10.456 -31.2285 9.008 -7411 4 13.8245 19.0713 15.6714 -4.89067 6.02882 4.66139 -7412 4 13.1633 18.7854 17.0362 1.8233 23.0525 -16.1268 -7413 6 48.6827 0.169575 20.4108 24.7259 -31.926 -14.6767 -7414 4 49.2893 41.6148 19.7702 -18.6338 21.3246 17.3218 -7415 4 48.933 41.6689 21.2514 -6.5025 5.85221 0.333279 -7416 6 43.0578 27.7881 11.5189 -10.6888 1.76469 -10.0665 -7417 4 42.6538 28.0077 10.6554 5.1393 -6.0393 10.108 -7418 4 43.5199 28.5835 11.7935 3.33621 0.984046 2.36511 -7419 6 25.7084 21.3766 35.1933 7.92601 18.71 -2.37973 -7420 4 25.8037 22.0957 34.5091 -5.30878 -22.9017 16.0752 -7421 4 25.4462 20.5484 34.7558 3.58761 11.0813 -0.636196 -7422 6 44.7325 4.60288 27.7529 -5.18995 0.47983 -9.95788 -7423 4 44.2388 4.02478 27.1463 1.34738 -4.40857 1.63455 -7424 4 44.3371 5.47709 27.6067 3.7052 -1.13476 4.16529 -7425 6 41.2786 11.441 34.2043 -0.416747 21.9122 -5.07112 -7426 4 40.7165 11.5703 33.4237 0.0697438 -4.14349 0.395824 -7427 4 41.2047 10.5155 34.4107 -4.51201 -19.8544 2.93408 -7428 6 19.8751 36.6454 2.03332 12.5662 31.6724 6.60432 -7429 4 20.6794 36.321 2.43856 -1.22315 -24.7147 -1.51883 -7430 4 20.0441 37.6041 2.15193 -20.0718 -8.75186 -9.57731 -7431 6 27.484 4.65653 6.35518 1.28922 -40.4385 -58.6648 -7432 4 27.5497 3.77116 6.72735 -1.75384 3.56143 11.9553 -7433 4 27.4257 5.33486 6.97498 -2.79123 31.4549 44.9969 -7434 6 16.8428 30.7659 39.9509 7.31092 -42.6244 -5.47757 -7435 4 16.9464 31.3097 40.7337 2.60533 1.47109 13.0941 -7436 4 17.1496 29.8303 40.1512 -5.48449 28.5555 1.20442 -7437 6 51.1542 15.2049 16.3406 35.1838 19.4064 -24.6303 -7438 4 51.2473 16.0791 15.87 -9.06363 -20.4986 13.944 -7439 4 52.0128 14.747 16.0894 -33.4595 8.32861 13.6861 -7440 6 49.9911 21.2271 35.9695 16.4294 -24.4585 13.2328 -7441 4 49.3547 21.5056 35.3276 -17.8928 6.13619 -17.6667 -7442 4 49.9245 20.2453 36.0087 2.29216 20.3869 -1.95357 -7443 6 34.4275 0.15221 5.68266 -0.837995 23.3079 0.855413 -7444 4 34.2957 0.929489 6.27037 2.93096 -11.6463 -16.4536 -7445 4 34.3488 0.459476 4.74482 0.623699 -7.30698 18.2278 -7446 6 48.316 11.5365 19.8846 -3.65813 -3.14803 11.8504 -7447 4 47.8503 11.3247 20.7373 6.31016 14.4835 -28.1035 -7448 4 47.7834 12.1052 19.2757 1.33379 -13.4076 20.6299 -7449 6 4.19577 39.4409 13.3607 25.3524 9.34899 10.5928 -7450 4 4.92582 39.74 13.9847 -33.0668 -7.48624 -17.3574 -7451 4 3.31127 39.5736 13.758 11.9971 1.78205 4.76714 -7452 6 8.7457 16.1809 8.53298 -1.62633 17.1572 -22.0575 -7453 4 8.74512 16.8853 9.19115 0.0519099 -7.3494 1.25428 -7454 4 8.72812 16.6658 7.66651 -0.023414 -16.7756 16.7144 -7455 6 29.0271 14.2712 26.5342 -13.8591 45.9397 20.1216 -7456 4 29.0757 15.2697 26.7309 6.93185 -43.1811 -12.6551 -7457 4 28.1042 14.0702 26.7795 9.9397 -3.04712 -3.53591 -7458 6 27.3813 14.5204 8.1419 -14.0666 1.8718 0.247246 -7459 4 26.4091 14.3966 8.10069 17.9482 5.30051 2.04476 -7460 4 27.5539 15.4689 8.31094 -4.76419 -14.5771 -1.3831 -7461 6 14.1301 27.2156 32.9232 24.3629 15.6041 -10.7258 -7462 4 14.926 27.3266 33.4685 -8.09546 -2.45296 -2.52419 -7463 4 13.4702 26.8045 33.4616 -14.5983 -10.6772 12.2116 -7464 6 31.6563 35.7792 21.2709 -29.1401 -25.1051 5.88501 -7465 4 32.0219 36.5153 21.7512 6.27263 14.1007 6.62418 -7466 4 30.8825 35.462 21.8184 22.9209 7.6802 -13.887 -7467 6 54.2186 28.7134 16.8958 -10.3287 11.0002 2.01575 -7468 4 53.5002 28.4234 16.309 3.24852 -2.61584 3.16662 -7469 4 53.9524 29.6107 17.1726 0.515277 -7.78004 -0.375364 -7470 6 9.0512 5.27483 17.1492 25.6572 1.38615 -17.9054 -7471 4 9.89534 5.12229 16.6101 -31.8522 3.085 22.1798 -7472 4 8.85255 6.23494 17.0921 1.81156 -15.0607 2.57474 -7473 6 29.6868 9.77258 26.5671 22.9889 -14.8503 10.4327 -7474 4 30.5444 9.2887 26.5838 -17.3341 11.3615 1.53321 -7475 4 29.3655 9.78642 27.4819 2.88877 -1.07091 -0.346791 -7476 6 44.0288 31.1766 32.1743 -14.2068 1.02328 22.4178 -7477 4 43.2475 30.9789 32.739 9.50682 -2.17476 -16.522 -7478 4 44.5788 31.7142 32.7564 8.88854 3.82935 -1.95952 -7479 6 53.49 3.62433 25.1454 11.2777 4.02107 -26.8953 -7480 4 54.1404 4.33507 25.1993 -2.49783 6.11479 15.045 -7481 4 53.6886 3.29227 24.2489 -10.294 -6.80459 12.4065 -7482 6 12.451 22.8746 3.38821 10.4278 8.96452 22.9237 -7483 4 12.7779 22.025 3.15024 17.1772 -24.972 1.67394 -7484 4 11.7815 22.9738 2.74712 -31.3784 16.165 -21.5343 -7485 6 39.42 29.6871 0.722943 17.2287 20.3893 -0.939439 -7486 4 39.938 29.1007 0.168548 -5.00448 -5.71086 -1.61555 -7487 4 38.6697 29.2119 1.03517 -14.5725 -11.7208 3.22357 -7488 6 13.7451 37.8179 23.0399 -3.65878 -32.3471 -6.65898 -7489 4 14.6418 38.0465 23.3627 -20.7195 15.519 -6.09735 -7490 4 13.1315 38.5597 22.9108 15.1185 11.2609 5.5967 -7491 6 33.3417 41.2334 -0.000336223 20.2285 27.8942 26.4667 -7492 4 33.8463 0.176253 41.7571 -17.5829 -26.3423 -4.93882 -7493 4 33.4991 41.0748 0.960438 -12.6248 -4.93214 -20.7453 -7494 6 15.7246 3.51737 6.33987 10.6879 -4.05507 31.4744 -7495 4 14.9251 3.29652 6.83809 -1.96505 1.65417 1.3128 -7496 4 15.4345 3.71468 5.4634 -8.944 6.24557 -22.4591 -7497 6 27.7713 30.7539 5.06912 -9.69485 -19.9648 -11.4393 -7498 4 28.5319 30.6575 5.66481 -7.77203 -4.90526 -3.90413 -7499 4 27.6074 29.8515 4.67882 9.36195 16.9347 11.4385 -7500 6 13.3277 7.57287 23.3467 18.1651 -5.37845 17.9429 -7501 4 14.1986 7.86136 23.0073 -11.0143 -2.49266 1.50668 -7502 4 12.7134 7.55433 22.6278 -8.93981 2.52131 -14.7715 -7503 6 38.3049 37.3174 27.9983 8.70135 -12.5747 15.655 -7504 4 38.3154 37.3922 27.0572 -6.74668 8.75695 -30.2201 -7505 4 39.0324 36.7087 28.1704 1.61648 -2.88985 11.5174 -7506 6 35.8266 12.5392 12.0897 -2.57405 -7.53067 12.8361 -7507 4 35.6491 11.5922 12.0112 2.97069 1.46586 -4.70523 -7508 4 36.2655 12.8127 11.2954 6.10525 2.83369 -11.8718 -7509 6 52.1153 23.0889 41.2774 53.3714 4.98692 -14.9993 -7510 4 52.5505 23.0114 40.3503 -31.9828 -2.74691 35.5054 -7511 4 51.1752 22.9201 41.2974 -16.3051 -5.99839 -13.4785 -7512 6 39.5458 11.6586 16.6081 -4.87816 2.10267 -34.9091 -7513 4 39.8889 10.7596 16.6462 4.61035 -3.54577 11.4771 -7514 4 39.4661 12.017 17.4857 2.58954 -3.33375 20.5696 -7515 6 0.680688 9.01153 7.97148 24.3969 36.1639 -33.0882 -7516 4 54.7452 9.01592 8.14854 -24.8099 -10.5681 8.91807 -7517 4 1.15172 8.32837 8.40327 2.66278 -26.2854 21.5078 -7518 6 42.3319 28.747 39.482 14.4944 54.9029 13.7373 -7519 4 41.6099 28.5069 40.0315 -24.977 -16.9351 14.372 -7520 4 42.5658 28.0062 38.9777 10.1954 -37.5926 -27.6332 -7521 6 38.7351 30.2774 16.2793 4.0737 2.19128 11.2593 -7522 4 38.8758 29.8829 17.1681 -0.562728 7.98522 -10.8415 -7523 4 39.3736 31.0181 16.2214 -9.64538 -12.7452 3.65311 -7524 6 7.59373 18.0328 0.655349 -39.2466 -13.429 1.02247 -7525 4 7.12412 17.545 1.38102 15.2508 10.2608 -15.5396 -7526 4 8.49503 18.0746 0.920891 28.7098 -1.69475 13.4339 -7527 6 33.7283 34.5883 24.1367 2.81913 -0.677006 -1.55035 -7528 4 33.5209 35.3543 23.5868 -0.36085 -2.23271 3.31185 -7529 4 34.0202 34.925 24.9956 3.1898 -0.550642 -1.12415 -7530 6 16.0108 40.0553 39.5926 -11.937 1.54577 -14.812 -7531 4 16.9471 40.1686 39.433 15.7688 -0.191962 4.71606 -7532 4 15.632 40.0274 38.6953 -1.55756 -1.47356 6.94311 -7533 6 4.49381 37.1265 21.8421 33.1234 -31.7004 -39.5319 -7534 4 4.78916 37.7556 22.4729 8.60512 21.3704 21.7375 -7535 4 5.32421 36.8863 21.3047 -36.9575 7.65083 16.8008 -7536 6 39.2568 20.1405 31.3294 -11.3601 -2.01094 -17.3558 -7537 4 39.2441 20.8952 31.9186 1.64276 10.2876 11.6417 -7538 4 38.6708 20.3662 30.5789 5.24327 3.39586 9.04201 -7539 6 28.5615 6.15748 32.0463 -1.77815 -13.6106 -5.56393 -7540 4 29.3688 6.39317 32.5024 4.03477 3.32162 5.90581 -7541 4 28.0645 6.97719 31.936 3.86184 3.53187 3.02469 -7542 6 9.32925 11.326 38.2021 -45.7357 8.82179 -18.9514 -7543 4 8.63026 12.0506 38.2047 26.1946 -20.5574 6.08922 -7544 4 8.95275 10.6938 37.5333 17.8336 11.1262 12.3014 -7545 6 41.6094 10.4714 6.86105 10.1449 -2.02989 30.4141 -7546 4 41.8033 10.1647 7.80154 -6.16714 11.7455 -31.3638 -7547 4 41.7667 11.4361 6.82819 -2.03628 -11.6206 -3.02795 -7548 6 3.11959 28.1093 17.6239 10.7497 -46.175 24.4008 -7549 4 2.68352 28.5892 16.9552 -19.7085 26.1099 -29.6067 -7550 4 3.57016 28.7359 18.1797 1.91623 14.188 4.79643 -7551 6 39.3448 12.237 19.2548 -14.1137 14.4353 18.1644 -7552 4 39.3198 13.2124 19.4672 -0.23776 -25.4214 -5.72266 -7553 4 38.5957 11.8144 19.7397 13.7352 7.639 -10.0067 -7554 6 2.76578 9.12322 31.711 10.2249 -26.7767 20.5709 -7555 4 3.2959 8.42892 32.18 -23.1647 11.967 -1.06293 -7556 4 3.41205 9.47362 31.1162 6.35119 16.2437 -14.7539 -7557 6 47.0978 34.3186 24.1743 26.4285 -20.6373 22.1669 -7558 4 47.9222 34.8155 23.9694 -26.3889 2.76484 -4.38573 -7559 4 46.3048 34.7125 23.8251 -6.69439 19.4391 -11.1209 -7560 6 41.2781 35.6191 9.5379 -9.82526 -0.200667 -5.59214 -7561 4 40.3156 35.6289 9.77314 20.3165 9.2235 -0.933793 -7562 4 41.677 36.5159 9.62264 -17.3348 -12.0484 0.717846 -7563 6 20.4662 31.4486 3.15039 -21.7086 3.64016 -5.07598 -7564 4 21.0332 31.2208 3.90109 -5.23001 0.711793 3.99895 -7565 4 19.5233 31.6154 3.43158 26.7394 -6.53789 -0.258783 -7566 6 33.2215 17.9623 24.8097 -0.453891 -1.34226 7.30289 -7567 4 34.1788 17.9667 25.0617 -18.0356 9.24084 -3.8919 -7568 4 32.8105 18.8566 24.8334 12.2893 -13.6267 3.75162 -7569 6 40.152 39.887 35.7648 -20.6867 7.32712 26.7748 -7570 4 39.5869 39.7633 34.9934 2.3303 1.35559 2.0998 -7571 4 39.5428 40.1203 36.5292 18.9615 -7.74514 -25.9591 -7572 6 4.86846 34.7127 16.4904 2.99496 1.45153 -7.51648 -7573 4 4.94748 35.6438 16.2302 0.473437 -5.16658 -0.520329 -7574 4 5.67201 34.2663 16.1683 2.12015 0.152524 1.06444 -7575 6 19.1332 11.0374 26.5471 0.604362 14.7011 2.3555 -7576 4 19.0986 10.7741 25.6217 -2.73437 -5.06461 -1.05922 -7577 4 19.4813 10.3027 27.0576 -1.53582 -10.5153 -0.687646 -7578 6 54.0201 13.9196 34.7874 -7.69802 -2.07317 -2.05829 -7579 4 53.0764 13.9769 34.9536 -3.33021 -5.1824 4.14914 -7580 4 54.0417 14.262 33.8952 13.8623 5.56658 -9.2157 -7581 6 1.84699 20.6587 5.20972 14.9439 0.361847 -39.2318 -7582 4 1.3018 19.9191 4.88605 -0.816153 4.45331 11.6833 -7583 4 2.38828 20.8916 4.39492 -13.6739 -1.13034 29.3331 -7584 6 22.2428 0.0912174 14.2544 2.10511 -1.36215 24.2926 -7585 4 21.4939 0.626329 14.4934 -11.4394 6.88953 -7.77601 -7586 4 22.6568 41.86 15.1175 2.53583 -3.69112 -10.285 -7587 6 4.95629 7.04242 24.7427 6.31781 -9.23371 -7.19194 -7588 4 4.17782 7.32111 24.2434 0.969413 4.1364 5.47863 -7589 4 5.24611 6.21648 24.3187 1.32276 5.05146 9.71893 -7590 6 41.4805 20.8726 34.9438 -11.2314 22.7349 11.4525 -7591 4 42.1022 20.1554 34.9949 12.4759 -11.6791 0.0999164 -7592 4 41.5325 21.3468 35.8092 3.20944 -13.6901 -15.0483 -7593 6 28.2157 1.74547 31.725 -9.95228 -2.94536 5.02618 -7594 4 27.5723 1.08944 32.0352 4.54694 0.234407 -12.282 -7595 4 28.3302 2.26918 32.5198 6.68924 9.49254 2.75715 -7596 6 16.8899 27.3746 36.9858 -9.49677 -4.03922 3.2671 -7597 4 17.2157 28.1459 36.4964 2.86939 -7.49192 -2.31982 -7598 4 17.0938 26.5386 36.5152 1.89463 15.2676 -1.69393 -7599 6 26.8243 38.069 8.34482 13.7761 41.6132 3.1747 -7600 4 26.4823 38.3279 9.22598 3.84792 -18.6223 -11.4711 -7601 4 26.785 37.1424 8.19579 -7.88027 -37.9853 9.71444 -7602 6 26.6634 33.7911 23.2273 -21.2745 -8.43567 7.74896 -7603 4 27.1019 33.3181 22.5212 7.04537 -0.372104 -6.32159 -7604 4 27.3305 34.169 23.7872 14.5385 6.50935 5.10733 -7605 6 10.2166 27.1183 30.2276 16.2509 -17.1331 -9.46175 -7606 4 10.1765 28.0583 30.3796 2.29392 15.9864 2.71565 -7607 4 10.9387 26.9511 29.5696 -14.5483 8.58048 15.0042 -7608 6 47.87 12.5975 5.02268 -6.13754 10.9902 -1.31963 -7609 4 48.1357 13.4822 5.34438 -4.36861 -17.8106 0.719643 -7610 4 48.2725 11.9144 5.56853 6.38614 1.6905 7.47062 -7611 6 53.3393 24.5639 22.1523 -40.2275 -1.43509 1.91788 -7612 4 53.1884 24.513 23.11 6.12251 -0.709171 0.80005 -7613 4 54.2538 24.6676 21.944 28.1496 2.10984 1.66559 -7614 6 29.4072 10.7569 19.3822 52.4151 15.8336 -9.71081 -7615 4 29.248 9.98119 18.8618 -10.0643 -15.3346 -6.0739 -7616 4 28.6282 10.9567 19.8417 -45.3483 4.87471 22.9978 -7617 6 39.4757 14.9522 19.5461 30.0359 -1.30311 42.0602 -7618 4 40.386 15.231 19.9108 -38.5728 -7.77311 -23.4682 -7619 4 39.3498 15.357 18.6983 1.75067 15.7407 -16.9704 -7620 6 32.8823 15.9838 22.806 -0.988113 9.61369 -4.64335 -7621 4 32.9657 16.5376 23.5815 3.43203 16.8704 5.79609 -7622 4 32.7087 15.1359 23.1895 -5.55033 -22.0541 3.57771 -7623 6 30.5481 1.96835 21.5144 8.4955 -1.31523 7.25762 -7624 4 30.7645 2.06729 22.4547 -1.5525 1.72807 -3.05596 -7625 4 31.3563 1.607 21.1075 -12.3766 3.94884 0.453046 -7626 6 0.972615 11.9937 3.31932 2.75381 16.0475 9.69945 -7627 4 1.12058 12.9582 3.29011 -6.67466 -9.20629 -8.78254 -7628 4 1.16803 11.7633 4.23669 1.49118 -7.35844 2.879 -7629 6 32.1487 30.4035 20.7885 -10.2937 2.79415 -8.64413 -7630 4 32.9584 30.6778 20.3377 1.19491 2.22071 -1.75985 -7631 4 31.4018 30.7106 20.2304 12.8433 -5.61998 7.3235 -7632 6 5.36663 35.5196 9.0005 -13.7636 -10.8617 -1.51226 -7633 4 5.10558 35.6694 8.09522 3.88385 7.21083 -8.97177 -7634 4 4.84313 34.7327 9.21079 3.19207 0.561776 9.20467 -7635 6 49.9075 13.051 32.2032 24.7068 -1.78611 -22.7634 -7636 4 50.5917 12.8604 31.4934 -20.1594 10.2365 23.451 -7637 4 49.3072 12.3042 32.1357 -5.12737 -3.80929 6.93874 -7638 6 4.31321 24.0956 1.58545 -15.4175 -15.0012 -21.2972 -7639 4 3.62325 24.7374 1.73273 -2.73087 12.0747 8.21305 -7640 4 3.96758 23.5799 0.823479 15.3265 9.07188 13.8923 -7641 6 44.1581 38.1227 12.3545 -1.42535 -29.4608 0.820402 -7642 4 43.4877 37.5183 12.7749 7.78878 22.0847 -6.23147 -7643 4 43.9706 39.05 12.5061 -8.83193 8.8938 6.46859 -7644 6 44.688 17.3349 22.7943 52.857 -4.21013 7.29678 -7645 4 45.2391 18.0521 23.242 -20.6522 -19.8992 -14.1432 -7646 4 45.3699 16.6167 22.57 -26.4285 25.231 9.0384 -7647 6 20.3608 11.6914 19.667 7.58964 -15.1508 -20.1027 -7648 4 20.0231 12.466 20.0832 -9.22037 21.7722 17.9466 -7649 4 20.541 12.011 18.7627 0.78957 -9.8802 4.31695 -7650 6 4.45783 15.4051 36.2022 4.17523 -10.6616 -1.13379 -7651 4 5.07913 14.7124 35.8925 -4.22209 9.46347 0.0108161 -7652 4 3.57023 15.0045 36.1544 3.18966 5.51307 1.04981 -7653 6 44.8105 39.5245 30.1712 -12.2097 -12.5983 -29.4865 -7654 4 44.6649 39.2374 29.2388 12.2423 8.81859 19.2473 -7655 4 44.0848 39.0946 30.6384 -0.298867 5.38951 7.86823 -7656 6 30.0635 3.50956 11.3278 16.0802 -2.39158 -40.3094 -7657 4 30.5444 4.30508 11.007 -11.8296 -5.04519 20.5985 -7658 4 30.1379 2.92562 10.5291 -8.6007 1.99314 24.6663 -7659 6 25.6288 24.8657 16.1423 35.3146 -5.68436 -0.158812 -7660 4 26.5897 24.7732 15.9989 -9.69879 -4.30362 -13.2764 -7661 4 25.6615 25.1054 17.0605 -14.6317 7.6504 23.2411 -7662 6 36.8074 29.8609 20.6529 -16.3286 -4.81766 17.6852 -7663 4 35.9316 30.2459 20.3982 14.0867 -8.19012 9.60149 -7664 4 36.7164 29.3161 21.4988 -1.56746 21.2483 -31.978 -7665 6 52.2273 17.0565 38.3075 -18.6216 -30.1938 15.1193 -7666 4 51.4912 16.4635 38.6201 23.7372 14.7716 -7.00173 -7667 4 51.7959 17.5937 37.6524 -0.777677 7.661 -6.77585 -7668 6 3.82637 23.6296 29.8591 26.0466 24.015 14.1033 -7669 4 4.67122 23.3872 29.4436 -4.98409 -4.75234 -2.50433 -7670 4 4.14214 24.3103 30.5173 -20.0237 -17.5461 -14.7603 -7671 6 6.36694 19.9104 41.0994 -7.87156 6.69529 -0.551213 -7672 4 6.75531 19.2216 41.6418 3.91706 -4.8357 7.00798 -7673 4 6.43687 20.7189 41.61 0.371167 5.3541 9.12827 -7674 6 28.9069 38.9219 35.3342 18.1363 5.4885 19.4373 -7675 4 28.4975 38.2544 34.8057 -13.0204 -17.6003 -18.1497 -7676 4 29.7244 38.4883 35.6529 -6.84193 6.3312 -4.3373 -7677 6 1.06391 30.294 34.4744 17.4659 -4.25802 33.126 -7678 4 0.923806 29.8092 33.6831 -4.92213 -16.9626 -31.6436 -7679 4 0.43107 31.0027 34.4841 -13.3738 11.5818 -2.38269 -7680 6 26.4433 22.0338 20.438 10.4135 -19.5508 3.73058 -7681 4 27.3849 22.2767 20.3653 -17.5193 8.20183 -1.91668 -7682 4 25.8117 22.75 20.2981 5.30742 7.62512 -2.77887 -7683 6 3.9439 18.647 22.686 19.6053 -30.212 14.064 -7684 4 4.76982 18.631 23.2404 -22.0254 9.00566 -12.7221 -7685 4 3.71052 19.5535 22.5456 -1.30938 28.7031 -1.82281 -7686 6 6.87955 39.3273 26.9921 -1.67667 -12.9446 -11.9216 -7687 4 7.1836 39.9129 27.6984 -12.429 3.42242 7.34442 -7688 4 5.90054 39.2886 26.9896 13.9064 15.8094 12.8698 -7689 6 43.976 41.7556 26.5281 4.8347 -4.89589 -5.39334 -7690 4 43.9038 0.242071 27.3891 4.48323 5.1383 20.2804 -7691 4 43.1144 41.9148 26.1591 -17.5097 2.26447 -13.804 -7692 6 31.7137 29.57 16.9845 -29.8695 1.84649 5.70955 -7693 4 31.0051 28.8814 16.8861 15.511 13.0746 -1.88966 -7694 4 31.2475 30.3377 17.3963 12.872 -19.7765 -2.8161 -7695 6 46.2467 10.9544 15.5549 14.6537 -15.0388 13.4913 -7696 4 45.2992 10.7621 15.4719 2.35584 -6.3837 2.44855 -7697 4 46.7422 10.1008 15.6673 -18.7057 18.8904 -8.1417 -7698 6 36.5806 15.025 25.8165 21.8026 1.76557 9.13915 -7699 4 37.3648 15.4873 26.2149 -21.7037 -15.0217 -10.3096 -7700 4 36.1201 14.6319 26.5704 -2.31195 -1.95921 2.19148 -7701 6 47.2758 22.6707 6.12549 -20.393 21.5378 -17.5673 -7702 4 46.5536 23.2672 5.80637 16.9751 -15.6011 5.88158 -7703 4 47.0174 22.4855 7.02503 2.56882 -3.04752 8.65489 -7704 6 27.5281 39.6653 17.8063 9.11062 13.5998 -14.667 -7705 4 26.6008 39.6971 17.5421 -9.18871 -3.65478 0.40423 -7706 4 27.5952 39.1072 18.5692 -4.91094 -8.97362 13.813 -7707 6 14.0432 27.9674 36.8911 6.42031 -13.692 3.20322 -7708 4 13.4093 27.2386 36.6831 22.3711 16.0651 -1.21324 -7709 4 14.9745 27.6178 36.9209 -23.5128 3.35359 -2.56993 -7710 6 33.7582 13.0225 13.8549 2.82411 10.3644 -10.1378 -7711 4 34.6192 13.1187 13.3682 -26.1927 -14.0119 11.7219 -7712 4 33.447 12.1034 13.9061 16.5995 3.21583 -3.74575 -7713 6 3.39066 17.4794 1.96807 -11.027 -24.2448 -29.9928 -7714 4 3.01559 16.7425 1.36999 17.4474 35.7284 24.3857 -7715 4 3.43148 18.2603 1.39088 -0.910914 -5.0095 5.82543 -7716 6 27.5636 2.76805 36.4448 23.3016 6.40537 7.49337 -7717 4 28.0874 2.94382 35.6362 -14.0128 -4.70143 5.95918 -7718 4 26.7201 2.39292 36.1778 -1.1877 -0.145823 -5.22631 -7719 6 21.3174 1.20043 18.721 3.60184 -34.5623 26.1973 -7720 4 20.9731 2.06802 18.64 -8.90193 33.3239 -10.7294 -7721 4 20.989 0.903829 19.6038 6.52339 -1.5964 -17.0558 -7722 6 11.8953 16.678 29.2972 -24.0209 -12.1876 15.7906 -7723 4 10.9907 16.5502 28.9196 20.2967 4.53139 4.03679 -7724 4 11.83 16.2797 30.2084 5.50538 14.3948 -24.2902 -7725 6 15.9723 29.4609 29.6333 0.682268 26.1612 18.9471 -7726 4 16.8848 29.3174 29.3467 -1.47573 8.2327 2.84191 -7727 4 15.9822 30.2485 30.2615 3.64459 -27.0302 -18.4378 -7728 6 42.9269 7.03734 4.5197 11.663 -6.03152 6.53833 -7729 4 43.4231 7.50219 3.8104 -1.91258 -11.2042 14.7177 -7730 4 43.564 6.5391 5.10838 -14.9069 13.4822 -19.2581 -7731 6 46.4099 26.3175 18.5001 -14.65 2.77244 -10.2078 -7732 4 46.6739 27.1133 19.0164 -10.4759 -17.1195 -12.5948 -7733 4 45.7242 26.5969 17.8403 16.3643 -1.95791 15.5671 -7734 6 26.8576 31.9381 30.1176 11.4414 -26.9795 -35.8502 -7735 4 27.1259 30.9869 29.8859 -9.79711 36.6724 15.314 -7736 4 26.5998 32.3006 29.2227 5.46388 -10.7605 29.9307 -7737 6 19.4818 37.6192 31.2596 -32.5143 -22.3469 33.0613 -7738 4 19.0962 36.8501 30.8088 8.72557 8.52431 -5.84089 -7739 4 19.0944 37.5229 32.1795 16.9146 13.3756 -22.466 -7740 6 52.3665 32.7318 12.7942 -5.34222 7.33615 -3.08781 -7741 4 51.884 32.8768 11.9489 17.9119 0.95058 7.1847 -7742 4 53.27 33.1068 12.8183 -18.0778 -3.45769 -11.3622 -7743 6 6.73992 9.26339 24.0285 -18.4022 -33.2824 -0.456279 -7744 4 6.43016 9.52976 23.1488 2.39009 0.543925 -1.37305 -7745 4 6.14044 8.50785 24.2751 15.0572 15.2043 -3.93749 -7746 6 39.7373 39.5658 25.499 -11.0807 -5.52867 0.517577 -7747 4 39.7453 38.628 25.2585 2.77876 5.57729 -0.31401 -7748 4 38.826 39.699 25.8216 4.65786 0.889055 -1.26295 -7749 6 24.0734 14.0105 21.1438 13.9648 5.3121 -25.5312 -7750 4 23.6065 13.6215 21.8839 -3.42696 -11.6299 6.48748 -7751 4 24.3304 13.3134 20.491 -9.48085 14.6929 20.6508 -7752 6 5.1987 41.7736 24.8713 10.0047 -19.0707 10.1325 -7753 4 6.05769 0.0475547 25.2635 0.547146 -1.74599 -5.91735 -7754 4 4.86042 0.69526 24.5593 -4.41349 12.4443 -5.8689 -7755 6 42.3687 20.86 21.2777 19.2234 -22.1312 -1.40502 -7756 4 42.3783 20.5581 22.1846 0.624409 -1.73106 8.2154 -7757 4 41.7113 21.532 21.2665 -20.5735 20.428 -5.9858 -7758 6 48.2425 15.3687 33.5924 -0.241089 -2.38933 -5.28694 -7759 4 48.6415 14.7162 33.0072 6.18243 -4.87195 3.86709 -7760 4 47.6596 15.8553 33.0028 -7.11438 7.34599 -0.780278 -7761 6 46.0202 38.2953 16.5865 15.7829 17.4793 7.01852 -7762 4 46.7193 37.7552 17.0318 -13.8218 15.7663 -8.05182 -7763 4 46.1673 39.253 16.8241 -2.73609 -24.364 -6.22008 -7764 6 4.62701 28.4898 21.3631 -35.4199 -38.8764 -1.71187 -7765 4 5.05003 28.7578 22.1614 14.3175 13.903 20.3467 -7766 4 4.23296 27.6059 21.6238 11.0236 23.568 -16.8729 -7767 6 20.5692 15.1618 18.3974 -2.72234 -3.16682 18.7699 -7768 4 20.0205 15.9086 18.1633 -0.374776 9.93651 -8.10169 -7769 4 20.1114 14.8073 19.1799 7.71486 -3.14336 -3.02048 -7770 6 16.2446 13.6415 17.4737 -35.4034 4.06645 -23.9936 -7771 4 16.1835 14.6144 17.5029 6.20848 -12.1 -0.082548 -7772 4 15.5556 13.4035 16.7727 24.4056 2.85778 27.0666 -7773 6 52.5084 30.9566 18.1567 -0.97573 -12.5044 17.346 -7774 4 52.0533 31.4717 17.4985 -6.50351 10.4198 -16.9401 -7775 4 51.7821 30.6074 18.6971 11.4062 2.54252 -4.46582 -7776 6 24.418 1.73203 15.7939 2.07222 -10.1482 7.47229 -7777 4 24.2447 1.14878 16.5739 0.390494 16.7143 -9.44633 -7778 4 24.1366 2.64887 15.952 -0.929678 -6.23215 5.34629 -7779 6 23.8719 5.08832 31.0744 22.7283 -21.9769 -16.2257 -7780 4 23.8146 5.92648 31.5054 -7.3092 22.9653 9.22328 -7781 4 24.8319 4.92382 30.9303 -16.6577 0.531409 1.66203 -7782 6 29.6615 30.9343 0.410524 16.5859 -5.2272 -6.83283 -7783 4 30.4171 30.5602 -0.0763344 -8.98044 0.909776 12.9407 -7784 4 29.1293 31.2514 41.5907 -13.3941 8.54792 -1.14443 -7785 6 32.8591 37.9003 22.5268 -10.9299 -3.56267 -2.34485 -7786 4 33.7082 38.1164 22.1304 5.81458 1.66065 7.83892 -7787 4 32.835 38.1832 23.4516 6.53001 6.08896 0.386172 -7788 6 16.4762 17.3653 33.758 -11.7596 5.685 -6.41316 -7789 4 15.9639 18.0545 33.2621 15.6067 -10.6469 10.7903 -7790 4 17.1589 17.009 33.1621 -6.01342 7.59956 -1.04496 -7791 6 9.22918 13.3839 27.5418 -13.213 -9.30661 16.5651 -7792 4 8.30942 13.5198 27.2923 -4.71042 4.84624 -13.6557 -7793 4 9.0972 13.1179 28.4658 14.0632 -0.809421 3.61995 -7794 6 43.4685 7.73978 17.2176 -8.6426 5.21856 8.44668 -7795 4 43.4054 7.77113 18.1985 3.14312 -1.73226 -22.4674 -7796 4 44.4071 7.82788 17.0033 -0.931382 -0.0897333 1.197 -7797 6 22.3132 24.3412 23.1703 -9.75348 13.1727 -0.0757149 -7798 4 22.7871 23.5122 23.2675 1.8966 -9.89464 -1.11237 -7799 4 21.5045 24.1854 22.6454 4.5924 -1.52242 4.18414 -7800 6 26.0037 32.9236 32.716 -4.33416 -0.788049 -7.61174 -7801 4 26.2455 32.6516 31.8136 -0.0498336 0.850388 -0.133699 -7802 4 25.1949 32.4304 32.9126 -0.360701 -0.787143 2.76329 -7803 6 16.9426 19.041 7.45715 -3.10994 24.472 -2.41526 -7804 4 16.308 19.3093 8.14456 3.13816 -6.91205 -2.30089 -7805 4 17.0114 19.8381 6.87129 1.57938 -24.3813 10.2947 -7806 6 48.1131 14.4569 27.5699 7.08917 8.35207 6.49885 -7807 4 48.0603 15.1245 26.8691 -1.5138 -4.18476 1.16992 -7808 4 48.1537 14.9494 28.4126 -1.96213 -3.76556 -9.73571 -7809 6 52.3834 41.7541 11.1123 -0.447482 12.3 22.2377 -7810 4 52.3153 0.228199 10.2442 -0.817032 7.00513 -16.5207 -7811 4 52.6623 0.571857 11.7011 -4.41087 -5.87968 -8.23494 -7812 6 36.3325 6.93202 12.7048 -8.66608 5.7588 -1.53482 -7813 4 36.3873 7.88419 12.9074 5.41886 -9.49824 0.0534512 -7814 4 37.2464 6.6206 12.6662 3.93968 -0.5832 -0.272047 -7815 6 8.24609 20.3242 16.6676 2.28714 -8.73249 -3.11806 -7816 4 7.99607 19.3797 16.5602 0.915774 9.85224 4.30221 -7817 4 9.21956 20.3717 16.6442 -3.81833 -2.78155 -1.09608 -7818 6 28.8059 40.3215 12.8316 -6.32157 -2.99739 9.80695 -7819 4 29.5356 40.2333 12.2314 15.0973 -2.52646 -11.1155 -7820 4 28.4555 39.4209 12.8947 -4.4969 5.39171 3.74805 -7821 6 18.1648 11.8204 16.9538 6.42365 10.4423 10.6103 -7822 4 17.6537 12.6149 17.1793 -7.21931 -10.1359 -1.31065 -7823 4 19.063 12.1656 16.925 9.05203 -3.86377 -1.18548 -7824 6 30.8803 17.4233 21.4874 -38.9186 -21.5127 -11.6054 -7825 4 30.1793 16.7188 21.4067 15.4039 25.3522 4.50617 -7826 4 31.5864 16.9116 21.8642 20.5617 -1.86838 10.7411 -7827 6 34.8073 19.4112 37.959 10.4013 19.2527 -16.7989 -7828 4 34.9062 20.1671 37.3279 -0.177011 -16.5385 16.965 -7829 4 34.2544 18.768 37.5084 -3.31564 -7.45818 -3.12702 -7830 6 35.8251 16.8879 29.2053 19.9429 8.12055 25.1888 -7831 4 36.604 16.4922 29.6427 -6.21008 5.15879 -2.88988 -7832 4 35.5164 16.1914 28.6524 -12.7517 -21.289 -18.0185 -7833 6 3.03682 32.2806 6.33235 -9.22618 28.6071 10.2197 -7834 4 2.10307 32.1357 6.11945 6.4331 -12.4482 -1.5948 -7835 4 3.56193 31.5065 6.1559 2.8275 -21.5224 -7.32445 -7836 6 26.8 41.6522 10.1614 16.4152 -10.6242 6.62789 -7837 4 27.6763 41.4103 9.75871 -19.2491 6.11251 13.5217 -7838 4 26.9685 0.0827479 11.0562 4.26354 0.263175 -7.76775 -7839 6 52.2755 24.564 24.8743 -17.4742 4.09161 11.4913 -7840 4 51.3068 24.6875 24.9545 12.6777 -6.48001 -7.54331 -7841 4 52.5704 24.9086 25.7267 7.88636 1.59704 3.61539 -7842 6 22.6859 22.6471 33.5865 3.00815 -0.389016 -3.70522 -7843 4 23.2377 23.2516 34.129 -18.2936 -9.34398 -1.8364 -7844 4 21.8798 22.3666 34.0572 9.18357 8.33181 5.74035 -7845 6 10.6559 14.2334 33.0439 8.40108 -6.88321 -2.71679 -7846 4 10.5166 14.9368 32.4181 8.42324 10.9453 -12.1325 -7847 4 9.76709 14.0756 33.3137 -17.8131 -11.8211 11.2552 -7848 6 21.913 10.8504 11.5417 10.0273 5.1408 -10.1307 -7849 4 22.8643 10.6911 11.6864 -4.5907 0.219491 7.97275 -7850 4 21.4519 10.7503 12.3817 3.5408 -3.26695 13.1151 -7851 6 38.3604 6.02409 25.8423 -7.72295 28.2176 13.9057 -7852 4 38.0159 6.28095 26.7202 2.23326 -16.155 -4.56644 -7853 4 38.4362 6.90267 25.4438 5.48615 -7.56939 -11.5178 -7854 6 30.9465 26.6393 38.5732 9.04128 -30.5088 -25.1958 -7855 4 30.9128 26.4505 39.498 -1.67119 3.99535 28.8865 -7856 4 31.0441 25.726 38.2186 -4.36445 16.9712 0.749916 -7857 6 30.1667 14.6301 35.4838 10.1392 5.1159 -4.4805 -7858 4 30.5216 15.3681 34.9096 -25.1579 -14.4294 10.0398 -7859 4 29.1929 14.5877 35.5299 11.6839 11.6021 -8.75286 -7860 6 12.5351 37.2243 16.9695 -17.9994 -5.54058 0.759354 -7861 4 12.9667 37.9067 17.4519 9.84296 27.0859 15.3185 -7862 4 13.2146 36.5653 16.9126 10.1753 -19.489 -6.1469 -7863 6 27.4306 21.5582 37.7184 0.323044 -0.91237 -2.80926 -7864 4 26.8919 21.7087 36.9418 -1.95891 -4.49412 -14.6911 -7865 4 26.9535 22.0297 38.3943 0.198826 4.23191 11.3586 -7866 6 29.6082 18.3788 12.6829 -3.7237 -11.7076 25.6006 -7867 4 29.4829 18.1024 13.618 2.9495 3.49705 -16.1413 -7868 4 28.7034 18.5321 12.3984 -4.77545 3.00323 -3.28229 -7869 6 2.3585 15.6468 0.175999 -8.20612 37.5639 57.3692 -7870 4 1.52386 15.5898 41.6501 -20.1916 -9.73007 -21.8008 -7871 4 3.00191 15.1099 41.6903 28.5072 -35.3577 -30.6151 -7872 6 17.8194 25.7234 4.22068 -18.7286 -4.35761 2.03057 -7873 4 16.8619 25.5897 3.93795 36.6055 5.10926 -2.3659 -7874 4 18.4291 25.8425 3.4621 -13.2431 -0.0346718 7.72723 -7875 6 41.7912 11.1794 20.2704 -4.7703 -4.22644 -3.97484 -7876 4 42.5222 11.2179 19.6258 -6.77094 -1.14571 2.2342 -7877 4 40.9861 11.4636 19.8126 1.73275 2.14556 -1.92771 -7878 6 38.0378 18.3863 24.0278 -3.74133 -10.331 -0.132081 -7879 4 38.4309 19.0888 24.5482 3.22643 8.24914 5.57345 -7880 4 37.9308 18.7305 23.1431 0.767244 4.53126 -6.25669 -7881 6 4.13298 13.9173 33.7521 30.6843 -35.3272 -10.2657 -7882 4 3.2388 13.7394 34.0326 -6.45696 -6.01886 0.999898 -7883 4 4.62487 13.0231 33.6052 -30.6419 39.0128 7.66426 -7884 6 19.1936 19.1847 26.5022 -1.72621 -3.50471 2.07629 -7885 4 19.5259 20.0399 26.2155 5.41694 7.89262 1.74938 -7886 4 18.9505 18.7515 25.6854 -0.500338 -7.01675 -4.74744 -7887 6 22.475 26.1945 25.3345 -21.4458 -23.9003 -3.16659 -7888 4 22.3709 25.4906 24.6814 -7.32491 -4.57374 0.352876 -7889 4 23.3013 26.5414 25.0733 33.537 19.6696 -4.44151 -7890 6 48.8098 32.073 32.5556 -12.1052 4.48194 -0.190297 -7891 4 48.9381 31.1381 32.4233 -5.03309 -16.3747 0.495313 -7892 4 49.6354 32.4434 32.2762 12.9514 12.9364 -2.07298 -7893 6 25.2177 18.014 27.013 4.13139 4.11129 3.02633 -7894 4 24.4991 17.5573 27.49 6.6231 -0.568789 -7.074 -7895 4 25.6482 17.4406 26.3525 -8.92874 -1.57445 7.95973 -7896 6 1.76475 41.5608 24.9549 2.89162 -9.06076 -21.1384 -7897 4 1.88611 40.794 24.3317 -1.07403 19.5272 24.3581 -7898 4 1.30092 0.287142 24.3881 5.67761 -7.93757 11.1942 -7899 6 18.6633 11.7702 10.8608 -14.1102 -15.1967 11.3789 -7900 4 19.5021 11.9001 10.4051 -2.67857 -1.17934 -0.0567829 -7901 4 18.6465 10.841 11.1975 0.382459 20.6246 -9.54243 -7902 6 45.6242 16.5573 4.85031 17.0541 -2.39304 -3.72853 -7903 4 46.5701 16.2411 4.85652 -23.9929 13.0597 -1.64852 -7904 4 45.6057 17.5078 4.58964 5.38323 -15.7737 4.77093 -7905 6 40.6798 36.3894 24.0177 5.99482 15.2006 -18.5281 -7906 4 40.7505 36.8152 23.1136 -3.68852 -16.1642 25.9152 -7907 4 40.7388 35.4259 23.9735 0.360603 0.79119 -4.57544 -7908 6 32.2161 36.322 4.9431 5.19197 18.2152 11.0878 -7909 4 31.5074 36.1415 4.30154 10.9387 -10.0795 -6.57323 -7910 4 33.0257 35.7839 4.88769 -13.0089 -6.05715 -7.93038 -7911 6 1.60369 14.6754 10.8168 -10.3056 7.30247 33.6992 -7912 4 2.33423 15.3134 10.9307 -7.1595 -6.86026 -1.25923 -7913 4 1.1476 14.6845 11.711 13.0511 -0.847163 -26.6328 -7914 6 35.0153 14.2871 28.0739 18.7596 2.69464 30.5166 -7915 4 34.8734 14.0618 29.0187 14.279 3.49385 -12.2543 -7916 4 34.1456 14.1907 27.7398 -26.4062 -1.19123 -20.5956 -7917 6 54.7157 6.11907 21.8609 -12.1949 -7.16094 1.89291 -7918 4 53.7846 6.03827 22.1577 10.7478 1.95047 -3.13077 -7919 4 0.0370646 6.90146 22.3147 2.89466 7.98076 3.79048 -7920 6 31.7642 16.9274 27.3665 -7.54316 -5.52924 6.90942 -7921 4 30.8348 17.1206 27.2023 -9.34166 0.83246 -0.0222557 -7922 4 32.1928 17.2544 26.5838 13.9998 7.82105 -16.2222 -7923 6 14.4504 28.0052 11.1087 -4.71237 -14.6735 4.6077 -7924 4 14.1081 28.8557 11.3451 -9.65694 14.7183 8.34222 -7925 4 14.826 28.1745 10.2406 5.25389 -7.26775 -5.19981 -7926 6 35.6627 19.4906 18.309 1.38743 3.66357 1.00844 -7927 4 36.0608 19.4502 19.1905 -8.3289 1.62604 -1.04031 -7928 4 34.971 18.8114 18.299 7.41978 2.58016 -0.85803 -7929 6 0.908295 12.7232 15.4509 -10.2874 -45.1283 5.64528 -7930 4 0.635795 11.7526 15.3361 10.0925 35.0181 2.47128 -7931 4 1.39513 12.719 16.2997 -3.76012 1.73199 -7.91518 -7932 6 52.7239 14.8052 20.9911 -10.1838 -50.8962 13.8805 -7933 4 52.1355 13.9729 20.9263 20.4043 37.1153 -0.0771148 -7934 4 52.3678 15.481 20.4204 -9.75671 2.85516 -9.21068 -7935 6 7.50014 6.78453 13.6112 45.6118 -3.77462 -0.237279 -7936 4 7.66407 7.72531 13.7166 -11.095 5.64184 -2.33744 -7937 4 8.44113 6.46934 13.5548 -33.3093 -4.56257 -1.46213 -7938 6 12.8693 29.1327 30.951 -35.1999 43.7452 -37.9705 -7939 4 12.911 28.5157 30.2274 6.73286 -14.9776 0.757022 -7940 4 13.2432 28.8129 31.7306 26.8069 -31.1286 39.1504 -7941 6 8.91269 29.9946 35.6682 4.82638 -20.5676 13.9142 -7942 4 9.08199 29.9869 36.6487 -3.4848 12.9743 -23.6701 -7943 4 8.85763 30.8835 35.2999 2.4913 8.97671 5.8399 -7944 6 29.2501 7.21193 5.56384 -35.3124 23.3999 -5.45769 -7945 4 29.8929 6.567 5.7677 24.3163 -25.3556 4.38867 -7946 4 28.4878 7.00912 6.14468 16.2636 8.35776 -7.44031 -7947 6 25.8882 9.2493 3.85609 -10.1418 -10.3657 2.14015 -7948 4 26.6938 8.77544 3.58522 -5.62061 -1.52714 -0.987441 -7949 4 25.143 8.71761 3.5088 14.4855 4.13341 2.07026 -7950 6 46.1828 19.5303 23.8452 27.5142 -8.79556 18.2338 -7951 4 47.0303 19.3932 24.4147 -29.6641 11.3761 -34.952 -7952 4 46.4302 19.9015 22.9687 10.0609 -5.49214 13.8961 -7953 6 18.6 35.3226 28.7813 33.9262 -21.2248 5.29661 -7954 4 18.5078 36.1255 28.2543 2.15121 5.76995 -5.3877 -7955 4 19.5645 35.0126 28.755 -37.0827 17.274 -2.06568 -7956 6 28.0068 22.625 32.1882 17.1638 -9.71048 -11.652 -7957 4 28.1161 23.0799 31.3381 -0.933036 0.686599 6.01892 -7958 4 27.1717 22.9224 32.5558 0.319614 0.839726 2.26602 -7959 6 25.9992 18.4251 22.6716 -8.51512 -6.6596 14.3523 -7960 4 26.8098 18.8237 22.3895 20.3106 6.57833 -11.9809 -7961 4 25.8253 18.8771 23.5162 -1.041 -7.57666 -6.79729 -7962 6 31.1689 23.0872 29.1831 -2.26749 -18.4759 6.78914 -7963 4 31.118 22.1592 28.8841 -5.05583 5.59361 3.05947 -7964 4 31.7418 23.5345 28.5581 5.1573 7.79625 -4.49352 -7965 6 36.6391 4.9259 0.480345 37.9344 10.2065 -26.5572 -7966 4 36.638 5.82198 0.886244 0.658013 -14.6584 -5.92388 -7967 4 37.39 4.95173 41.699 -35.1456 1.42767 30.4358 -7968 6 36.484 21.0145 10.0529 -6.00883 6.48187 8.17175 -7969 4 36.4042 20.1763 9.58301 3.63574 2.58382 -3.15576 -7970 4 35.8773 20.9259 10.8015 2.14778 4.06152 -0.936887 -7971 6 50.5993 25.1947 18.3919 -28.2028 12.9956 8.35013 -7972 4 49.869 24.7394 17.9262 9.19638 1.46827 3.55355 -7973 4 51.4482 24.8993 18.0848 11.0575 -8.08323 -5.33222 -7974 6 50.1824 39.6576 12.4356 -22.7811 -7.9912 15.1349 -7975 4 49.7705 38.7879 12.6194 4.75387 11.043 -2.88475 -7976 4 51.0686 39.4751 12.1603 15.8621 -1.53988 -6.37666 -7977 6 30.5412 12.4178 4.80566 -15.3128 -2.78075 25.3711 -7978 4 30.0752 11.5776 5.01806 10.6669 11.6172 -5.90727 -7979 4 31.021 12.2424 4.01172 11.531 -8.83371 -18.4272 -7980 6 28.9525 15.4713 21.8679 -2.36978 -36.4192 26.6063 -7981 4 29.1677 14.6271 22.3934 -7.66269 33.2693 -19.6276 -7982 4 28.1632 15.8063 22.3348 7.54721 -2.84859 -11.2752 -7983 6 14.0684 9.5583 16.997 2.7235 -6.59901 -0.744295 -7984 4 14.8185 8.94582 17.0717 -0.0957791 5.7783 -3.11218 -7985 4 14.4323 10.4488 16.9992 1.00571 2.57913 -1.39277 -7986 6 4.48903 30.1743 11.858 18.777 -10.7052 13.2768 -7987 4 4.86699 29.7697 12.6847 -17.3276 7.96894 -17.1216 -7988 4 3.53137 30.2861 11.9207 -0.113543 -0.314347 4.01346 -7989 6 40.8874 8.0652 23.6541 0.993335 -18.0149 -24.6412 -7990 4 41.0014 8.23968 22.6934 -0.45004 7.6784 15.1082 -7991 4 40.7726 7.0925 23.6399 1.20374 9.92563 8.58777 -7992 6 53.7462 35.0557 16.7061 9.98011 -4.48961 -22.2856 -7993 4 53.4827 35.8182 17.2307 0.000554802 6.10184 -1.96461 -7994 4 54.0786 35.3449 15.8213 -7.68991 -0.599931 23.4559 -7995 6 53.7073 10.1889 20.3718 -10.7517 16.2467 -19.4493 -7996 4 53.8408 10.0262 19.4272 8.41512 -10.415 5.03553 -7997 4 53.1338 10.9644 20.2967 0.731263 1.06205 11.7435 -7998 6 4.58979 27.075 7.78807 17.6653 -15.6715 -1.75621 -7999 4 5.19096 26.32 7.80399 16.3727 7.79792 -3.24405 -8000 4 3.78382 26.6199 7.94519 -28.415 1.42755 3.38346 -8001 6 50.5066 22.5306 22.1436 -1.2339 18.6921 5.41009 -8002 4 50.2802 23.3104 22.6632 -2.8343 -11.09 7.6214 -8003 4 50.7991 22.9414 21.3369 4.56213 -7.53044 -15.8119 -8004 6 7.04346 27.196 21.628 9.41144 -9.96736 11.8657 -8005 4 6.8407 26.6883 22.4668 -8.25713 16.2835 -27.3312 -8006 4 6.26031 27.4748 21.116 4.26862 -9.43237 15.0117 -8007 6 23.8265 35.0499 16.5937 18.3012 9.13896 26.4348 -8008 4 24.7235 34.8381 16.9269 -14.9485 7.62278 -2.13189 -8009 4 23.7604 34.5968 15.7714 -3.77201 -11.7597 -22.7393 -8010 6 5.98953 23.8983 3.91761 -44.4181 -14.5448 -1.98234 -8011 4 5.398 23.9519 3.1318 15.794 0.401012 8.45254 -8012 4 5.35617 23.6012 4.61938 19.6174 4.72778 -5.04958 -8013 6 38.7401 25.0729 19.1247 8.8169 4.91643 10.7802 -8014 4 38.7862 24.2921 18.5681 -1.99613 -8.272 -9.94687 -8015 4 39.0639 24.8191 20.0061 -2.94522 4.87881 -4.09917 -8016 6 12.9717 18.2893 10.6182 7.92512 -8.05782 -7.58833 -8017 4 12.0999 18.3162 10.2013 -2.76008 2.25331 1.21984 -8018 4 12.8722 18.6085 11.5165 -3.68712 5.29275 10.5515 -8019 6 38.0382 41.2423 21.0873 4.88219 -19.6272 -0.152698 -8020 4 37.2014 40.7765 21.2484 2.63704 8.02432 -2.02816 -8021 4 37.8835 0.198079 20.7163 -11.2369 15.8096 -5.69312 -8022 6 6.98214 22.8682 17.8394 -5.75247 -17.9204 -1.57462 -8023 4 7.61723 23.542 17.6412 15.6839 20.0065 -5.16874 -8024 4 7.3587 22.0484 17.4826 -2.13646 0.815835 3.23256 -8025 6 24.1186 19.368 12.3177 21.0449 6.23804 -24.2445 -8026 4 23.9242 19.844 13.1293 -4.19124 -3.15082 3.8784 -8027 4 23.743 18.4928 12.3308 -10.9397 -14.908 7.07664 -8028 6 44.2213 28.4415 4.8153 2.12167 -7.44997 -5.8313 -8029 4 44.3009 28.0649 3.91739 -1.37383 9.18016 5.99771 -8030 4 44.2294 29.4128 4.74855 1.01191 -3.53144 -7.03239 -8031 6 23.3167 8.29314 21.4338 -0.329791 14.7993 14.6131 -8032 4 22.995 9.23581 21.5362 7.25813 -26.2111 -7.67418 -8033 4 23.1349 8.01865 20.5229 -2.36131 4.58949 1.23489 -8034 6 14.3464 2.19127 18.5365 1.00479 -5.05512 -1.33996 -8035 4 14.3534 1.26337 18.7781 -10.0191 -8.45544 9.17935 -8036 4 15.2531 2.29149 18.2562 13.6881 11.5937 -7.27189 -8037 6 28.0536 31.92 34.134 3.57463 -14.0429 -1.6048 -8038 4 28.4517 32.4188 34.8607 -2.66641 5.35559 -0.0232853 -8039 4 27.3246 32.4577 33.7701 8.655 -3.68096 2.2403 -8040 6 53.3502 24.7032 18.2649 -24.2711 -41.2818 -9.83264 -8041 4 53.5194 24.6019 17.3193 6.96991 8.47211 -0.102973 -8042 4 53.68 25.5059 18.6169 17.7955 37.5084 3.34479 -8043 6 36.8031 28.4187 22.9511 -10.1554 -0.61119 21.2214 -8044 4 36.5106 28.9054 23.7358 4.15696 8.73481 -5.19311 -8045 4 36.1845 27.6911 23.0035 -2.36033 -17.8474 -9.79811 -8046 6 21.8885 30.5877 27.4793 -3.11585 8.28062 7.57241 -8047 4 22.2621 31.0993 28.2061 -3.96796 1.5816 4.48491 -8048 4 22.5937 30.5949 26.8475 10.2249 -8.24374 -18.6607 -8049 6 10.2833 3.28406 27.2289 -24.5304 -2.91212 14.6365 -8050 4 10.0443 2.76427 28.0065 14.6588 -5.9106 -2.57837 -8051 4 9.44832 3.75002 27.1066 2.80489 10.142 -13.305 -8052 6 37.7147 24.9939 29.6988 5.24245 -12.5023 -10.1121 -8053 4 38.3581 24.5533 29.0689 -23.3017 1.4918 23.5498 -8054 4 37.1779 24.3214 30.1874 12.7329 5.56421 -12.5271 -8055 6 9.13611 24.4367 14.4784 20.7258 8.96054 28.4908 -8056 4 9.04651 24.998 13.735 -5.03994 20.1658 -22.0876 -8057 4 8.726 23.6299 14.2398 -14.2121 -32.2206 -7.12291 -8058 6 52.7755 31.4643 7.39569 14.5412 -1.52098 0.484013 -8059 4 52.3413 32.1584 6.88884 0.00633314 4.2069 -4.47258 -8060 4 52.0605 30.9716 7.79316 -9.34275 -9.05133 5.36325 -8061 6 21.3287 5.44475 36.4975 17.176 -11.9485 -14.2877 -8062 4 20.7483 5.50715 37.2619 4.90115 -8.53405 7.77147 -8063 4 21.912 4.64524 36.5597 -18.1029 20.6035 4.94996 -8064 6 25.1768 37.2214 4.32574 4.31983 -25.8241 -7.35849 -8065 4 25.4326 36.64 3.57657 -1.88178 18.0132 5.09494 -8066 4 24.8685 36.5657 4.9694 -1.32139 10.7309 7.78615 -8067 6 33.9928 17.4475 18.2473 -28.4515 -0.0793518 28.5349 -8068 4 34.2921 17.0113 19.1053 -15.0281 13.9289 -20.2703 -8069 4 33.1064 17.9171 18.4165 33.1367 -21.5966 1.81969 -8070 6 37.9532 37.4932 25.2939 -37.7872 -15.4269 -20.4394 -8071 4 36.979 37.7096 25.1406 34.3292 -3.43428 9.43604 -8072 4 38.1084 36.7677 24.6487 1.47089 11.2608 10.0337 -8073 6 5.08061 4.87523 15.8431 -4.86231 -7.56388 -2.23136 -8074 4 5.78156 4.1744 15.8759 -9.54967 26.0091 2.46095 -8075 4 5.43258 5.75 16.0822 6.78608 -13.538 3.56789 -8076 6 14.1628 7.20449 7.78038 25.2379 -5.46067 -13.6381 -8077 4 13.5115 7.54153 8.36471 -22.6877 11.2017 23.85 -8078 4 13.6914 6.99143 6.96374 5.13235 0.836748 0.117842 -8079 6 24.9714 10.8522 38.0874 21.7543 24.8019 24.8971 -8080 4 25.3733 11.7327 37.9223 -2.75098 -14.513 10.3213 -8081 4 24.5811 10.6456 37.27 -22.0988 -18.3607 -37.1034 -8082 6 35.6792 7.98105 22.8098 -5.63995 -0.874411 -1.68631 -8083 4 36.3111 8.66137 23.0699 5.30437 2.23481 0.770305 -8084 4 35.3824 8.20038 21.9134 0.62108 2.61089 2.3422 -8085 6 24.7967 29.145 22.4166 8.97915 1.26062 2.6062 -8086 4 24.9285 28.4017 23.0307 -7.24415 3.31799 -2.87627 -8087 4 23.8684 29.1691 22.1667 -6.93063 -5.53381 0.128782 -8088 6 38.5003 31.6402 38.4666 0.118802 17.9484 -3.06973 -8089 4 38.5639 32.3894 37.8454 -0.598215 -11.959 -0.514206 -8090 4 38.3632 32.08 39.3134 -2.43734 -3.45212 12.1107 -8091 6 7.2246 33.2558 15.4144 3.93224 14.6297 14.7993 -8092 4 8.10558 33.3578 15.8508 -19.4169 -6.69939 -13.0108 -8093 4 7.30076 32.5035 14.7978 2.24681 10.3389 8.67702 -8094 6 43.3411 23.605 1.45378 1.24542 -6.52262 6.11498 -8095 4 43.1714 24.3501 0.858367 5.1295 -5.17404 3.37123 -8096 4 44.2208 23.7695 1.84296 -12.8059 2.13297 -8.4534 -8097 6 3.53981 32.9157 14.8686 -7.67856 -8.73615 6.98201 -8098 4 3.60397 33.2061 13.9566 0.668747 6.43783 -7.96574 -8099 4 3.81902 33.649 15.4236 5.03764 7.23473 -0.501009 -8100 6 25.308 21.7722 8.24708 3.37146 -12.406 14.7751 -8101 4 26.0573 21.1741 8.36562 1.41198 8.84323 -6.65363 -8102 4 24.826 21.6647 9.09095 -1.64121 7.89428 -12.8382 -8103 6 43.814 15.3562 17.763 -19.8802 -3.64728 -7.58039 -8104 4 43.4756 15.1225 16.8733 5.20247 0.973102 4.81929 -8105 4 44.7686 15.2775 17.7045 7.07231 -2.77487 -5.74422 -8106 6 15.7867 16.2594 16.6597 40.7179 11.0003 30.8626 -8107 4 16.4245 16.8568 16.2414 -0.344326 0.180624 1.74019 -8108 4 15.1074 16.2177 16.037 -41.8412 -2.72902 -33.087 -8109 6 31.9018 12.864 11.5221 -0.527288 11.9796 -2.61342 -8110 4 32.4715 13.19 12.2739 -15.261 0.218931 -18.2329 -8111 4 31.4408 13.5947 11.0331 13.5047 -10.6099 18.0399 -8112 6 18.2179 5.3463 10.1762 9.71532 5.2148 -18.3501 -8113 4 17.8204 5.66693 9.33813 -2.6575 -7.74782 15.1878 -8114 4 17.5556 5.18411 10.851 -9.29453 0.73034 -3.17809 -8115 6 23.0812 39.0781 10.9303 2.37609 8.25457 -4.90642 -8116 4 24.0025 38.8104 10.892 -1.10831 -0.594451 2.83356 -8117 4 23.078 39.9337 10.4697 -7.78026 -4.85412 5.47405 -8118 6 46.8678 33.747 8.76655 -5.11485 44.7451 24.4631 -8119 4 46.406 34.5339 8.40734 -0.304999 -21.98 -10.152 -8120 4 47.1603 34.1422 9.62028 2.09293 -20.2864 -11.5212 -8121 6 31.2447 39.9321 20.2226 -0.330123 -0.585472 -4.98228 -8122 4 30.8504 39.3151 19.5884 6.05804 4.05585 3.92388 -8123 4 32.2053 39.9316 20.0453 -4.95864 -1.44581 -1.12159 -8124 6 15.9016 33.0949 19.7876 25.1907 -5.52815 -22.1207 -8125 4 16.0748 33.7133 19.0349 -1.92202 -14.988 11.1016 -8126 4 16.5267 32.3265 19.6592 -15.8695 19.8556 5.2806 -8127 6 32.5654 39.9188 2.66304 17.6014 -10.2623 -15.3377 -8128 4 33.3417 39.59 3.14903 -11.9816 5.68487 0.865723 -8129 4 31.9971 40.348 3.29791 -5.42947 4.08066 9.69521 -8130 6 50.71 12.2088 3.91621 6.45352 -28.1924 -19.9843 -8131 4 51.4315 12.4725 3.33505 0.00989865 5.72461 1.55844 -8132 4 50.5782 12.8645 4.57223 -0.528152 29.464 22.8196 -8133 6 44.6954 2.75762 12.1022 0.941183 0.541095 5.21442 -8134 4 45.0772 1.91827 11.8337 7.97486 -4.13832 -5.1586 -8135 4 44.7961 2.76556 13.0748 -3.12194 1.26681 -13.8655 -8136 6 11.5119 11.9446 31.6555 0.0165034 5.87533 16.9496 -8137 4 11.2786 12.7291 32.193 1.1093 -4.42098 -1.85793 -8138 4 11.5615 11.2089 32.2952 3.49417 6.36211 -10.0029 -8139 6 4.75553 10.0442 10.5026 -0.613356 7.28818 -1.41717 -8140 4 5.04922 10.2458 11.3982 -0.190174 3.033 -2.19553 -8141 4 4.45357 10.8768 10.0827 4.22944 -8.29703 6.91569 -8142 6 17.1004 25.0221 20.585 20.8628 27.7333 -27.8469 -8143 4 16.2314 24.7196 20.7848 -24.892 -11.5638 6.73224 -8144 4 16.9745 25.5771 19.7683 4.93088 -15.3222 19.1034 -8145 6 48.1032 4.75801 14.8026 37.7024 -16.8658 7.41777 -8146 4 47.1817 4.923 14.9438 -21.3904 13.2232 -6.86149 -8147 4 48.4894 5.33532 14.1187 -17.354 1.23192 4.40994 -8148 6 18.8584 3.1094 3.41532 -17.9645 -5.092 -5.76247 -8149 4 18.4858 2.24853 3.65522 2.22195 0.198645 3.24183 -8150 4 19.7914 2.99202 3.55078 21.8001 -2.9136 1.99579 -8151 6 35.4214 26.4496 29.0479 -25.0869 -13.2406 8.30382 -8152 4 35.4596 27.2122 28.4766 3.66886 10.9927 -9.48044 -8153 4 36.2884 26.0622 29.0901 17.6032 -4.12101 -3.28535 -8154 6 32.3918 31.2203 12.8386 46.3164 14.9485 -1.56764 -8155 4 31.5927 31.2548 13.3118 -34.7781 -0.694705 18.2501 -8156 4 32.2274 30.836 11.9945 -8.46486 -12.2685 -25.2096 -8157 6 32.9972 28.3347 37.5978 -19.2694 -14.478 20.0019 -8158 4 32.1604 27.8545 37.87 25.9433 12.8245 -4.2723 -8159 4 33.4478 28.5699 38.4425 -10.0504 -3.89776 -17.7975 -8160 6 45.4943 24.785 10.3174 -24.9891 51.3938 13.5053 -8161 4 44.9436 25.3819 9.72852 18.6998 -28.2383 15.0369 -8162 4 45.6946 23.9769 9.88803 3.95472 -26.3164 -24.236 -8163 6 14.7646 31.7016 3.17106 -12.494 -4.77828 16.8956 -8164 4 14.1278 32.382 2.84257 8.55448 -13.727 9.9815 -8165 4 14.4774 31.2925 4.03575 0.781246 20.1514 -26.73 -8166 6 31.932 7.70259 4.29822 28.2629 -13.9597 32.9447 -8167 4 31.5142 6.8338 4.23667 -1.26054 0.464616 -4.26218 -8168 4 31.5893 8.26695 3.64018 -18.9284 22.0156 -31.588 -8169 6 42.5661 17.3076 32.2072 4.58091 20.9841 -12.8778 -8170 4 41.6153 17.2751 32.1225 -13.9289 -9.63208 0.974916 -8171 4 42.7549 18.1312 31.7017 7.23855 -15.1499 9.29454 -8172 6 13.801 23.1802 23.5544 20.5107 -9.18639 9.43365 -8173 4 13.5559 23.799 24.2431 -7.02941 8.57916 4.58982 -8174 4 14.6139 22.757 23.9348 -15.8084 7.21572 -12.2969 -8175 6 10.7224 7.09218 3.96878 16.2046 -14.1912 -58.7694 -8176 4 10.4615 7.01435 4.86228 -13.7845 -9.22242 34.898 -8177 4 10.4899 6.25858 3.45399 4.94204 24.1379 24.5516 -8178 6 28.7975 8.66057 17.8838 -26.4281 5.00156 -27.4828 -8179 4 29.5466 8.31163 17.3909 5.91048 -3.96826 -5.96201 -8180 4 28.1517 8.96764 17.1731 20.0585 -9.38402 22.2692 -8181 6 19.4445 29.3512 26.6402 -27.7559 12.8002 37.2849 -8182 4 18.9931 29.7086 27.4672 16.1765 -10.1498 -30.4371 -8183 4 20.3292 29.7071 26.6996 8.86807 3.45557 2.67965 -8184 6 40.676 40.9989 14.5783 -1.81287 -10.2023 17.4849 -8185 4 40.8703 41.6798 13.9303 10.8761 5.87921 -5.34291 -8186 4 41.4788 40.6754 15.0317 -0.103076 9.61372 -9.63617 -8187 6 46.2568 14.0853 31.7234 10.6503 -1.46249 4.93376 -8188 4 46.4506 13.1375 31.7184 -3.79774 3.42444 -0.601084 -8189 4 45.5065 14.2191 31.1522 -8.96365 0.976246 -7.34606 -8190 6 36.7103 36.3065 8.39844 -19.1971 -27.2559 -17.1971 -8191 4 36.3822 37.2167 8.51449 20.2374 -9.10083 14.9839 -8192 4 37.462 36.0245 8.9597 -8.83948 23.9771 2.75809 -8193 6 30.7983 32.4219 38.0908 -28.9564 1.76229 18.7871 -8194 4 31.3387 31.9445 37.476 23.2205 -2.83162 -11.1976 -8195 4 31.2894 33.1287 38.5298 9.85106 -3.61838 -6.87003 -8196 6 47.9 8.84746 10.1809 13.9026 13.2481 4.99334 -8197 4 47.2314 9.07534 9.54683 -14.9306 19.0332 -8.73943 -8198 4 48.008 7.93273 10.003 10.2061 -26.7512 4.08493 -8199 6 24.4282 17.0027 30.9766 -8.14946 0.47403 -13.61 -8200 4 23.7021 16.9118 30.3187 14.132 0.581257 9.28124 -8201 4 24.0019 17.1514 31.8341 1.66288 -1.35228 -5.87998 -8202 6 40.5039 5.09263 4.48513 -8.56504 -6.5373 -32.2613 -8203 4 41.2755 5.64065 4.37578 16.2932 9.35997 9.97847 -8204 4 40.1843 5.0523 3.55179 -2.89742 -7.45623 19.6864 -8205 6 52.5794 28.086 6.91602 -27.2154 -20.1235 6.97783 -8206 4 52.4353 28.6007 6.11552 3.94928 -0.112987 0.705634 -8207 4 51.6969 27.6552 7.08025 27.1089 14.7333 -4.60736 -8208 6 36.0629 32.381 23.6142 9.17579 -16.9148 -2.4755 -8209 4 36.5407 32.2813 22.7776 -1.15674 3.38979 7.41153 -8210 4 35.7113 33.2654 23.6252 -9.15386 11.2493 0.0331211 -8211 6 23.6552 31.8756 22.7565 -25.0136 1.00336 21.6204 -8212 4 23.73 32.5959 22.1297 15.1034 -2.64982 -11.1407 -8213 4 24.3343 31.2055 22.6866 12.2933 -0.39941 -10.0267 -8214 6 0.736598 24.4641 41.7072 -6.94393 1.55048 -19.4095 -8215 4 1.23654 24.8288 40.9522 -3.95743 -2.80997 9.51773 -8216 4 54.8325 24.2702 41.3637 13.4109 4.08216 3.5339 -8217 6 15.9721 8.97822 19.8125 19.0517 -22.613 16.6544 -8218 4 15.5497 8.29105 19.3091 -4.28185 -9.24838 -10.3339 -8219 4 15.6128 9.78815 19.5092 -16.7051 35.4763 -13.493 -8220 6 33.1656 12.5735 20.0353 32.8597 -32.3881 -24.7893 -8221 4 32.9817 11.6196 19.8453 -6.04217 28.6875 8.28399 -8222 4 34.1172 12.6638 19.7368 -32.1809 10.6792 11.3696 -8223 6 7.04894 24.9401 26.3957 -12.3425 -2.00741 -5.21086 -8224 4 6.75821 24.2907 27.0478 8.01299 -1.99342 6.24335 -8225 4 7.89161 25.3154 26.6505 10.7219 -3.29246 12.7441 -8226 6 44.479 22.5508 36.9163 -6.8399 -5.44184 13.3083 -8227 4 43.5214 22.4098 37.071 12.5044 3.3732 -3.51472 -8228 4 44.595 22.7899 36.0028 -4.86816 3.42784 -13.6235 -8229 6 39.2745 23.7032 25.1197 -32.3737 -81.7274 9.17932 -8230 4 39.5886 24.5492 24.9992 24.471 68.8814 -13.2187 -8231 4 38.7456 23.4691 24.3377 5.22396 6.33701 6.85867 -8232 6 20.3646 2.19602 36.9892 -4.85825 6.83938 3.69158 -8233 4 20.3067 1.45038 37.5971 1.4243 -8.23943 -2.36696 -8234 4 20.3942 1.88275 36.0861 3.42557 -6.35335 -2.19064 -8235 6 22.8664 19.5513 3.67104 -13.2265 5.28042 31.2857 -8236 4 22.7633 19.8561 4.6286 7.01101 -9.22167 -32.7463 -8237 4 23.7764 19.7315 3.39612 4.00916 2.85623 5.02623 -8238 6 31.705 12.5768 34.6039 18.8969 7.7197 42.0834 -8239 4 31.1026 13.3107 34.9476 21.2302 -23.3848 -5.30166 -8240 4 32.3569 12.3026 35.3493 -33.8624 17.1964 -33.567 -8241 6 12.9851 10.2105 25.0956 -25.1193 26.0078 -38.429 -8242 4 13.6149 10.0452 25.7619 22.39 -15.9831 32.7066 -8243 4 12.4963 9.40655 24.9468 1.34194 -14.9569 1.62555 -8244 6 27.2621 0.584423 13.2176 -28.6404 -16.2485 2.71576 -8245 4 27.7069 41.6292 13.1518 2.13728 8.59646 -2.51953 -8246 4 26.2847 0.395264 13.1771 23.0038 6.72582 -0.601928 -8247 6 5.66006 24.9398 13.9833 -7.43295 9.91556 10.5591 -8248 4 4.70147 24.9177 13.9802 -4.26929 -7.73667 -8.07402 -8249 4 5.82197 25.381 14.8221 8.41297 -1.15026 -0.763214 -8250 6 22.9908 17.9523 0.521723 7.02411 -25.4698 12.909 -8251 4 22.4592 18.6506 0.142784 -9.22706 3.46645 -2.83539 -8252 4 22.3527 17.3052 0.930771 13.2695 22.3169 -13.3733 -8253 6 33.0935 25.4243 5.46557 -9.38497 -10.8046 -8.60877 -8254 4 33.4966 26.2756 5.44764 14.9521 17.8538 5.01915 -8255 4 32.9941 25.2035 4.5344 -2.6207 -6.96629 2.5324 -8256 6 8.53079 7.95552 17.4804 7.64086 6.41223 -26.4035 -8257 4 9.4001 8.35547 17.2638 -9.73917 -4.33322 7.64386 -8258 4 8.4487 7.94255 18.4286 4.30191 2.70426 16.6029 -8259 6 26.8371 0.685906 2.89773 -0.256761 31.01 4.86999 -8260 4 26.7806 0.433187 3.83156 0.637082 -2.67537 2.60738 -8261 4 26.6279 1.66343 2.89109 6.9325 -26.481 -2.08778 -8262 6 50.0417 34.7142 15.6334 -23.0288 8.72534 -30.9996 -8263 4 50.5531 35.2159 14.9759 6.02412 -4.51102 12.1494 -8264 4 49.1615 34.6714 15.1751 14.0914 -5.62478 19.352 -8265 6 46.2791 4.99946 11.1196 9.7179 12.4772 -7.72995 -8266 4 45.7827 4.25534 11.4529 -10.6417 -11.5364 6.26713 -8267 4 46.9456 4.6214 10.5389 1.00953 -4.68959 -1.2994 -8268 6 33.7936 38.6123 35.3918 15.2762 25.882 47.4359 -8269 4 34.0305 39.0866 36.2411 -6.18084 -28.1229 -24.2145 -8270 4 33.6134 39.3784 34.8506 -5.42867 -1.33428 -20.4371 -8271 6 30.8282 25.8371 41.2172 -7.09757 -19.9215 -22.3179 -8272 4 31.1427 24.9253 41.375 1.19635 8.28989 4.89631 -8273 4 31.1138 26.3841 0.0263053 10.2845 10.2166 22.0109 -8274 6 50.2275 0.982033 24.4751 51.8832 -7.79127 14.7425 -8275 4 49.5671 0.561213 23.9746 -37.5145 -10.5742 -20.1648 -8276 4 51.0349 0.46072 24.2534 -17.6876 18.8276 11.0022 -8277 6 31.2908 0.710797 19.047 -2.09434 13.573 -1.22083 -8278 4 30.4487 0.672221 18.611 -14.5784 9.11804 -11.7691 -8279 4 31.2841 41.7946 19.4765 8.98672 -35.4229 20.9418 -8280 6 39.0741 29.5515 19.1276 -25.3595 -21.9961 15.137 -8281 4 38.1807 29.4949 19.565 25.109 7.94863 -12.7917 -8282 4 39.4837 28.6866 19.3452 2.49072 15.8212 -6.56848 -8283 6 21.6546 17.5955 25.8962 -6.78298 15.7545 0.118362 -8284 4 22.0482 18.4938 26.0891 -15.3421 -24.4294 -5.96834 -8285 4 20.8112 17.7106 25.4012 18.8301 2.25602 6.45745 -8286 6 35.0761 28.7988 27.4227 3.11164 -5.22767 30.3338 -8287 4 35.4099 29.4705 28.0422 -1.31539 -7.25274 0.820077 -8288 4 35.176 29.229 26.5925 2.58985 10.308 -31.8228 -8289 6 30.7102 25.4463 11.6589 -5.09223 14.513 32.8165 -8290 4 30.6059 25.8179 12.6014 3.72506 -14.6402 -39.0718 -8291 4 30.6061 26.1982 11.055 2.14208 -0.820709 7.44645 -8292 6 7.34821 15.124 12.3469 -7.98455 -28.7648 8.02815 -8293 4 6.65824 14.4547 12.1585 7.38491 7.52419 4.72727 -8294 4 7.19665 15.7511 11.658 -2.78105 24.4343 -15.0907 -8295 6 16.8417 26.815 7.05419 -24.774 6.28148 -21.5195 -8296 4 17.6138 26.5995 7.5418 30.7131 -10.23 16.3776 -8297 4 17.1302 26.9688 6.14022 -2.93816 -3.28182 4.8763 -8298 6 29.5112 33.0571 30.9901 -17.2684 21.8413 -16.809 -8299 4 28.6007 32.8494 30.6893 8.91061 -10.9491 6.08618 -8300 4 29.8939 32.355 31.5124 -6.62171 -19.0922 5.25725 -8301 6 14.1054 2.12143 30.9174 -7.90077 -11.4283 37.211 -8302 4 14.0041 2.00138 31.9209 0.0297695 4.78336 -39.0496 -8303 4 13.7376 1.30679 30.5176 6.48361 9.45743 4.44265 -8304 6 15.6593 22.2688 2.88796 -26.3773 12.8308 -8.6958 -8305 4 16.4059 21.7286 3.01985 35.1738 -16.1657 6.55343 -8306 4 15.0005 21.6175 2.62854 -10.183 2.33344 0.69621 -8307 6 23.7324 29.1178 40.9691 12.375 28.71 1.88761 -8308 4 23.2563 30.0016 40.9795 15.1309 -27.3218 0.73938 -8309 4 24.7153 29.2815 40.9372 -24.8849 -3.40565 0.339466 -8310 6 38.1289 14.1609 13.7163 11.3988 23.3452 4.961 -8311 4 37.6355 13.3641 13.8052 -15.0683 -25.2976 3.04519 -8312 4 38.877 13.9408 13.1592 7.07353 -0.711776 -7.39216 -8313 6 35.2564 26.5047 15.5196 1.21661 4.3606 12.6683 -8314 4 34.5556 26.4436 14.8616 -0.145442 -0.409522 -0.299569 -8315 4 34.9009 27.0522 16.256 4.1263 -8.75979 -17.8666 -8316 6 19.0944 34.7315 16.477 3.93496 0.874554 38.8769 -8317 4 19.5342 35.6013 16.5498 -2.87948 -9.96323 -9.99674 -8318 4 19.0181 34.4301 15.5899 3.71142 3.01681 -30.4069 -8319 6 18.1805 29.7449 35.7046 18.8444 17.1873 -3.97052 -8320 4 18.2235 30.6593 35.335 -4.4784 -20.2666 13.1463 -8321 4 19.056 29.5886 36.1261 -9.76671 1.23141 -6.47371 -8322 6 54.1188 22.2659 24.9096 4.78421 -24.6774 -19.3149 -8323 4 53.6441 21.8104 24.1769 10.121 5.11789 9.9801 -8324 4 53.5075 22.9378 25.1661 -14.3198 20.1313 5.7187 -8325 6 30.3323 10.3375 34.0061 7.35563 0.641124 -2.21855 -8326 4 29.5734 10.4043 34.5817 -14.4555 0.0376959 9.72957 -8327 4 30.8213 11.1653 34.1487 -3.17747 -4.67635 -0.590304 -8328 6 38.3211 33.8974 18.5888 -1.32754 -0.89807 -0.720993 -8329 4 38.9926 33.271 18.8539 2.22312 -19.1913 3.89796 -8330 4 38.8713 34.6655 18.5317 3.84957 24.8056 -1.31283 -8331 6 22.4809 14.1697 34.431 -22.1622 -5.27184 -37.8541 -8332 4 22.5433 13.5186 33.673 0.822047 20.8222 24.5167 -8333 4 23.1773 14.0067 35.0533 16.0768 -5.18569 10.3575 -8334 6 38.0141 0.622036 2.34694 9.03481 -5.1652 10.3599 -8335 4 37.7113 1.09641 3.1189 -18.3016 16.1314 2.00329 -8336 4 38.7028 0.120019 2.79986 6.1006 -11.8827 -16.4842 -8337 6 38.8847 41.1446 10.3004 16.8495 57.0142 -12.497 -8338 4 38.6453 0.212884 10.3117 6.47193 -33.8599 -1.337 -8339 4 38.2374 40.7573 10.8541 -26.8649 -17.5582 22.9746 -8340 6 53.4109 21.9211 38.9712 27.3607 0.0645619 -10.5759 -8341 4 53.0384 21.9801 38.0859 -10.7304 2.2749 -0.0111998 -8342 4 54.3668 22.0571 38.7395 -19.1981 -5.88632 12.9741 -8343 6 39.9872 12.7205 36.288 -8.06793 35.3321 20.4333 -8344 4 39.087 12.3834 36.3725 1.18883 -9.13664 -3.11406 -8345 4 40.4905 12.1818 35.7009 7.36107 -20.124 -19.0601 -8346 6 48.4463 17.2389 40.5967 -24.7278 4.81563 12.4078 -8347 4 47.5665 17.6971 40.4852 25.7833 -12.0744 1.257 -8348 4 48.3987 16.886 41.5134 6.10343 4.05346 -12.6042 -8349 6 32.0413 9.35688 40.0251 1.84943 -9.41379 10.5137 -8350 4 32.8011 9.3156 39.4233 -4.71533 -3.42986 0.347912 -8351 4 31.8082 8.43016 40.2864 3.98001 20.4877 -6.20043 -8352 6 31.7351 22.4909 6.36481 -11.9835 4.517 5.86255 -8353 4 31.4453 21.6589 6.79738 2.31245 15.2673 -2.59345 -8354 4 31.3521 23.2372 6.88711 4.39127 -22.2776 -7.77946 -8355 6 51.0252 2.58567 21.5888 12.0252 -3.79771 4.1956 -8356 4 51.3852 1.69652 21.8042 -1.91984 13.1306 -1.09782 -8357 4 51.7712 3.19849 21.4753 -6.25067 -9.48202 2.92476 -8358 6 13.6387 22.0486 12.1519 25.289 13.6281 9.24284 -8359 4 14.4553 22.4795 12.4841 -9.12946 -7.35477 -7.44936 -8360 4 12.9422 22.6971 12.3091 -5.69931 -0.254566 -0.690626 -8361 6 23.6098 24.0343 14.6404 -2.85842 21.3712 -30.1324 -8362 4 24.3054 24.4792 15.1401 1.72137 -5.65962 3.08819 -8363 4 23.5196 24.6041 13.8393 -4.42688 -17.9982 21.1692 -8364 6 9.32217 4.85318 31.2328 11.4746 -4.61869 -4.10735 -8365 4 8.43042 4.86168 30.8848 -9.06213 4.49291 -0.279243 -8366 4 9.25495 5.26013 32.106 -3.85952 -1.36 2.0258 -8367 6 16.6786 26.3118 18.041 -30.5179 5.83101 -14.1852 -8368 4 15.8205 26.6594 17.6987 9.23568 -14.6779 7.38956 -8369 4 17.2149 27.0871 17.9121 20.6972 11.6613 1.32787 -8370 6 5.1068 13.5155 11.5503 -9.62018 18.629 -29.2057 -8371 4 4.37741 13.3629 12.1623 -7.62379 -0.222526 0.540006 -8372 4 4.70689 13.979 10.7366 10.5209 -18.4088 37.9064 -8373 6 29.6181 23.6359 8.06142 -1.81854 7.21422 -1.70755 -8374 4 29.1888 23.4521 8.90141 0.206013 -3.23773 -0.0922606 -8375 4 29.4815 24.5976 7.98987 7.61073 -10.2969 -5.72522 -8376 6 0.801466 7.54671 27.8401 6.5354 -3.49578 -14.7683 -8377 4 0.895859 7.27352 28.7573 1.78004 -0.979843 7.25552 -8378 4 1.54585 8.15528 27.6648 -11.1939 -10.5496 5.25649 -8379 6 15.4336 9.77253 0.489553 0.922542 4.3707 -1.35473 -8380 4 16.0351 9.34865 41.7726 4.14277 -6.55565 2.56274 -8381 4 15.4857 9.31476 1.34042 4.74784 -1.15717 -0.337147 -8382 6 18.8008 0.0730809 34.105 -10.3773 -6.96418 -21.8764 -8383 4 18.5081 41.5423 33.2731 5.22569 12.9238 15.5106 -8384 4 18.5071 0.998566 34.0742 -2.68781 1.40869 -5.2752 -8385 6 18.7326 30.7673 29.1559 48.9948 -22.8293 28.8452 -8386 4 19.5421 30.7479 29.7792 -35.6741 -9.01286 -31.0748 -8387 4 18.496 31.6741 29.187 -17.0068 24.787 -0.45657 -8388 6 48.459 16.4997 36.139 1.45519 10.5028 1.01521 -8389 4 47.6111 16.9857 36.2164 10.4415 -5.87096 -2.55811 -8390 4 48.4968 16.1176 35.2432 -2.18798 4.21486 5.30298 -8391 6 43.8007 0.467658 29.2569 28.3678 -13.8677 -3.77703 -8392 4 42.8971 0.305725 29.4937 -25.3214 -1.14832 5.94808 -8393 4 44.2622 41.5592 29.5347 -3.4854 12.8866 -0.12306 -8394 6 16.7282 13.8764 21.3804 -5.85841 5.25102 8.86173 -8395 4 16.2274 14.7005 21.5266 6.94274 -6.60805 -7.01164 -8396 4 16.607 13.4327 22.2267 1.29648 -4.09529 1.45702 -8397 6 17.3848 13.434 26.2514 27.8708 0.579352 -19.8612 -8398 4 18.2073 13.6243 25.7048 -28.5107 -7.2193 21.7409 -8399 4 17.5944 12.6077 26.718 -2.1357 3.12496 0.608863 -8400 6 48.1647 10.2208 23.7049 7.80266 -18.7522 13.388 -8401 4 47.9825 10.5204 24.6118 -3.05612 1.76991 -8.97221 -8402 4 48.0139 10.9468 23.1026 -1.19683 7.34816 1.26356 -8403 6 28.2773 17.9142 17.8758 3.72989 18.9709 -15.182 -8404 4 29.0682 18.432 17.6259 -4.1904 -8.84834 4.2635 -8405 4 28.5441 17.0749 18.25 8.7895 -11.8779 5.35139 -8406 6 54.0848 38.1774 23.6862 8.79068 2.20397 4.23058 -8407 4 0.0366427 38.003 23.4974 -14.1536 0.885634 -1.20583 -8408 4 53.5245 37.5494 23.203 6.54807 -0.952262 -0.611804 -8409 6 8.48984 18.3998 11.4055 -13.462 -3.57414 27.789 -8410 4 7.65602 18.6961 11.043 -9.38292 3.75479 -0.915161 -8411 4 9.09748 18.5243 10.712 30.3826 3.02886 -30.4498 -8412 6 45.9441 12.8818 11.0222 -16.4049 1.91652 -6.40765 -8413 4 46.711 12.6299 10.4835 -7.54952 -0.564906 -6.57768 -8414 4 45.1235 12.7466 10.4771 21.7466 0.735613 7.10643 -8415 6 16.2215 8.79448 14.033 27.9098 -14.9816 6.01142 -8416 4 15.5522 9.3752 13.7952 -53.829 20.9905 -11.5495 -8417 4 16.9359 9.40542 13.9326 31.9466 3.3348 3.59486 -8418 6 42.7223 13.3863 21.3918 29.8224 16.7773 6.64199 -8419 4 41.9142 12.8874 21.2836 -9.67718 -3.29752 -8.9243 -8420 4 42.6271 14.312 21.0975 -16.0363 -11.184 0.152454 -8421 6 20.9977 40.4228 16.4707 19.2311 -21.9074 5.84064 -8422 4 20.7341 40.0536 17.3362 -0.495629 5.04161 -8.05599 -8423 4 21.8212 39.937 16.2081 -24.2166 11.8961 5.45251 -8424 6 45.6397 11.4296 32.9439 38.4109 -29.1814 -9.99274 -8425 4 46.3321 10.7493 33.2028 -28.4056 24.9384 -5.22126 -8426 4 45.113 11.6624 33.7013 -7.79747 1.97566 18.4384 -8427 6 26.9602 8.8599 24.2968 13.5915 2.79356 4.8338 -8428 4 27.3951 9.75608 24.2837 -6.20264 -27.5971 5.81865 -8429 4 27.4821 8.2415 24.8764 -5.62896 20.549 -11.158 -8430 6 18.9707 2.44141 29.3655 -2.01209 17.0873 0.653095 -8431 4 18.2519 2.38593 30.0124 -1.45633 -1.83702 1.76482 -8432 4 19.0982 3.39915 29.1871 -0.208097 -9.69202 4.76181 -8433 6 8.2396 29.1642 19.724 -7.67611 -9.48635 17.3168 -8434 4 8.16332 28.9052 20.6672 2.00381 4.74558 -18.2193 -8435 4 7.79264 28.4685 19.2154 1.97612 2.42161 3.19163 -8436 6 9.03293 34.3085 18.6392 -6.8245 -3.51508 -5.57673 -8437 4 8.73043 34.3576 19.5508 2.61936 3.47829 -5.40237 -8438 4 9.19173 35.2194 18.3614 3.83285 -0.179546 -0.301582 -8439 6 10.1806 11.9309 11.2378 5.33181 -8.21116 5.18339 -8440 4 10.4199 12.8404 10.9987 -8.38943 -3.43734 -3.26379 -8441 4 9.2213 11.8063 11.1618 4.16708 15.3888 -2.40164 -8442 6 35.7388 21.6853 36.1571 -21.2187 21.2566 3.59668 -8443 4 35.0074 22.3505 36.1843 15.9506 -16.0405 0.715421 -8444 4 36.3839 21.978 36.8321 -7.05156 -5.2756 -8.86951 -8445 6 17.0774 12.5078 36.39 -5.14261 15.8003 12.7424 -8446 4 17.3404 12.7479 37.2961 -4.35419 -1.09545 -7.6232 -8447 4 17.4977 11.6659 36.234 4.71638 -15.3379 -7.50181 -8448 6 37.1607 13.034 34.2837 0.889917 6.85814 -56.1323 -8449 4 36.6144 12.2451 34.135 3.16712 2.80772 8.73621 -8450 4 37.2953 13.1592 35.1962 -1.91867 -3.10361 40.6259 -8451 6 38.9747 29.5563 13.2253 1.18838 24.1885 -12.4362 -8452 4 38.8174 28.6959 12.8484 -2.87796 -16.626 0.178868 -8453 4 38.7606 29.548 14.1582 -0.666122 -3.30753 9.89159 -8454 6 0.17037 29.343 29.4884 -1.26324 3.91124 -27.2421 -8455 4 0.785297 28.6867 29.1327 1.78511 -2.78426 6.40223 -8456 4 54.9717 29.8735 28.6813 -2.47422 -4.8209 18.3172 -8457 6 15.9286 0.264913 12.7638 2.77369 8.97324 -0.606717 -8458 4 15.3998 0.564835 11.9867 -4.35739 -9.72902 15.1241 -8459 4 15.3918 41.7399 13.4663 -4.26125 7.58409 -15.055 -8460 6 3.98508 11.9472 8.79546 -10.0423 -23.9471 10.8905 -8461 4 4.30821 11.7435 7.92681 6.40121 -7.70989 -16.6116 -8462 4 3.96465 12.8834 8.77069 -2.75643 37.1798 9.03734 -8463 6 24.0517 23.6768 19.9772 9.9875 -0.396554 0.578582 -8464 4 23.5025 22.9354 19.7663 -8.47693 -16.0962 -5.40355 -8465 4 23.4442 24.2751 20.4024 2.14545 13.6845 6.88162 -8466 6 4.48152 2.30986 23.9923 -27.0109 23.4084 27.373 -8467 4 4.59263 2.40669 23.0716 9.73085 -3.6317 -36.525 -8468 4 3.6479 2.81506 24.1139 10.3345 -10.6947 10.8816 -8469 6 33.0856 27.6588 33.8383 -8.68317 -6.77689 0.893276 -8470 4 33.3543 28.5605 33.6822 -2.66039 14.7626 -6.22211 -8471 4 33.7694 27.2718 34.3804 4.93538 -5.90298 8.33006 -8472 6 11.4012 21.7076 6.08442 -20.9181 -7.28975 6.20623 -8473 4 12.3452 21.6439 6.06884 23.6791 -0.506282 -5.12853 -8474 4 11.1369 22.1078 5.25059 3.06155 -0.534748 -3.52863 -8475 6 37.2275 13.5312 23.6107 -13.7454 14.8127 9.96245 -8476 4 37.2011 14.0176 24.4689 -4.04457 -8.03454 -15.7104 -8477 4 38.0738 13.1109 23.5305 19.2281 -7.80113 -1.86698 -8478 6 5.00929 21.0475 33.3676 1.03993 27.0325 -33.9401 -8479 4 4.24931 21.2691 32.771 13.0002 -8.94008 10.7478 -8480 4 4.70945 20.492 34.0664 -10.4226 -16.4153 18.9759 -8481 6 18.2024 37.5737 26.9347 11.0126 -1.54132 -8.69207 -8482 4 17.8515 38.4557 27.1129 2.92195 -1.85995 -3.39903 -8483 4 18.9058 37.6892 26.2602 -8.80934 -3.84756 9.96821 -8484 6 19.7475 16.1502 4.67922 -0.59461 -5.69737 6.80756 -8485 4 18.938 15.9829 5.17999 -0.503733 6.42822 -3.53139 -8486 4 20.452 15.899 5.29485 1.51569 2.54074 -3.7554 -8487 6 54.0588 32.502 15.5791 2.11509 -30.3723 -27.0265 -8488 4 54.9193 32.2734 15.944 -2.03587 2.87368 2.60187 -8489 4 53.7148 33.1889 16.1175 -9.21817 24.1266 16.9863 -8490 6 31.1319 3.81908 36.7331 -8.52453 -12.3767 5.98224 -8491 4 31.0251 4.01663 37.6709 2.24281 6.85123 1.97341 -8492 4 30.7371 2.93942 36.6325 4.48759 4.53933 -4.77061 -8493 6 11.8397 14.3559 5.95013 17.712 13.5011 32.6048 -8494 4 11.8882 13.4483 5.64785 3.21485 -4.29204 1.16864 -8495 4 12.4103 14.428 6.79608 -23.3682 -9.2254 -38.5841 -8496 6 30.4732 33.6903 6.46877 -20.5926 30.9984 10.0988 -8497 4 30.0823 33.146 7.15741 -0.571027 -8.82817 5.88036 -8498 4 31.0368 33.1406 5.95739 18.3645 -25.6031 -16.3825 -8499 6 12.7874 0.539502 21.6719 -8.5062 -5.44338 -19.1545 -8500 4 12.0427 0.939271 21.1459 16.6961 -1.79193 22.1421 -8501 4 12.8959 0.982969 22.5241 -5.23507 7.86641 1.50036 -8502 6 52.7588 7.2218 26.198 16.8025 28.3515 6.33153 -8503 4 53.4065 7.96379 26.3423 -21.978 -17.2249 -4.05545 -8504 4 53.0631 6.80021 25.3976 -2.37526 -6.61619 -6.13258 -8505 6 39.7335 40.8867 3.73325 7.25622 8.93714 -16.4459 -8506 4 39.3445 40.0379 3.8542 -7.03998 -23.1188 -2.87281 -8507 4 39.6833 41.2661 4.59764 3.93702 15.0893 17.324 -8508 6 20.121 31.9222 21.9838 -6.71526 -6.20654 6.86321 -8509 4 19.4522 31.9772 22.708 13.7594 -4.46219 -12.9776 -8510 4 20.3423 32.8279 21.7497 1.41177 8.86705 -0.575134 -8511 6 12.8675 35.0031 4.45346 44.828 -17.7313 4.60062 -8512 4 12.2237 35.6716 4.40701 -39.658 29.9319 -2.18346 -8513 4 13.7076 35.4677 4.24983 -7.53722 -6.26381 -0.0905995 -8514 6 24.0625 33.6591 24.8433 7.47563 8.71661 -6.22666 -8515 4 23.7256 32.9086 24.3593 -5.011 -9.84395 -6.229 -8516 4 24.8651 33.8891 24.3525 -1.08488 0.504411 0.449776 -8517 6 40.1566 40.8925 22.745 3.65995 -18.1772 23.084 -8518 4 39.459 41.1173 22.1514 -10.4135 8.7075 -19.9273 -8519 4 39.655 40.5713 23.5068 11.7186 -0.819555 2.88668 -8520 6 15.5608 2.83174 38.4548 -17.961 4.93292 18.3513 -8521 4 14.8017 3.44348 38.6509 23.1729 -8.01231 -13.692 -8522 4 16.317 3.27039 38.0376 1.48109 9.53369 -0.90723 -8523 6 41.0116 9.17543 16.9495 15.4695 -4.08523 -13.4682 -8524 4 41.9148 8.77619 16.8957 -14.8555 5.86712 4.74383 -8525 4 40.5932 8.80873 17.73 -3.00249 -3.47282 8.63794 -8526 6 43.1871 41.3934 9.57744 -8.69666 -18.4537 3.1119 -8527 4 42.3844 40.9156 9.26306 10.8189 9.37287 1.53096 -8528 4 43.2581 0.273962 9.04681 -5.03874 9.79533 -5.6553 -8529 6 24.9044 37.9223 30.7828 -39.5154 -3.84946 22.9815 -8530 4 23.9949 37.8093 31.2426 42.0603 4.56965 -20.1335 -8531 4 24.7148 38.3736 29.9542 -2.24489 2.04808 -5.58176 -8532 6 2.22015 5.33054 16.4399 10.309 -8.52293 4.98471 -8533 4 1.84892 4.56193 16.8809 -9.36945 -1.25887 4.31387 -8534 4 3.13742 5.05729 16.2666 0.349453 6.20437 -4.74718 -8535 6 1.39717 14.946 19.1428 25.1228 15.6369 3.14315 -8536 4 0.624759 14.5201 18.7755 -11.3456 -6.79531 3.66607 -8537 4 1.29195 14.9418 20.1112 -7.64559 -2.97115 -5.19376 -8538 6 34.323 26.551 23.7054 -6.89575 15.1076 -7.90432 -8539 4 33.5377 26.6273 23.1515 0.482254 10.7241 -2.26295 -8540 4 34.2298 25.6735 24.0419 5.3831 -21.6418 13.1607 -8541 6 41.9187 21.8289 37.5387 -12.5221 18.6557 -0.654717 -8542 4 42.0641 21.2774 38.3263 -4.73604 7.9145 -4.0056 -8543 4 41.3184 22.5612 37.831 11.9642 -17.2916 1.51119 -8544 6 39.4187 37.6728 12.6286 4.8532 5.57593 -2.65087 -8545 4 38.7905 38.0203 13.2933 13.4683 3.10916 -9.30227 -8546 4 40.0129 38.4033 12.3216 -17.7433 -13.1833 12.1033 -8547 6 30.24 35.8848 2.88572 49.7685 -5.59713 18.4489 -8548 4 29.7974 35.0543 2.80033 -9.93294 -19.906 -6.06696 -8549 4 29.6668 36.5692 2.63166 -32.6151 32.1739 -11.9765 -8550 6 50.3574 12.2906 11.0327 -10.5999 -17.0186 -10.0309 -8551 4 50.5337 13.0768 11.5186 9.60091 28.0994 7.49192 -8552 4 50.105 11.6994 11.7365 -4.43527 -18.2768 5.14926 -8553 6 38.4177 1.51331 34.6454 7.78381 -17.0522 33.0946 -8554 4 38.2699 2.04814 33.8899 -7.54861 16.9144 -29.9652 -8555 4 38.0471 0.642488 34.4678 -6.5188 -5.83242 -9.72252 -8556 6 23.4539 32.2409 29.2188 -19.2438 22.9381 45.5983 -8557 4 24.0079 32.8299 28.7229 8.54827 0.527122 -15.0299 -8558 4 23.2413 32.797 30.0413 4.80705 -31.5817 -31.7916 -8559 6 36.5701 38.8746 8.90535 32.3223 -9.33237 29.2552 -8560 4 35.9325 39.4424 8.49935 -20.4423 23.0824 -8.61697 -8561 4 36.7801 39.1579 9.82993 -12.7327 0.605838 -19.3651 -8562 6 35.8737 15.8498 32.4386 8.92141 19.9053 -4.5399 -8563 4 36.1418 15.4504 33.2665 1.19933 -3.86396 7.25653 -8564 4 36.5179 16.5897 32.2945 -14.9335 -15.4114 1.1633 -8565 6 22.2892 21.8291 41.5841 -16.2626 10.7882 17.5339 -8566 4 22.1223 22.8053 41.6744 16.5914 -23.4811 -7.73209 -8567 4 23.1242 21.6534 41.1409 10.4107 9.35007 -4.50107 -8568 6 24.3606 38.6964 37.0146 17.4204 12.5043 -4.63866 -8569 4 25.2779 39.064 36.9978 -17.1771 -5.52971 -1.04157 -8570 4 24.4186 37.9719 37.6407 -4.78215 -9.12154 5.30794 -8571 6 45.8441 22.068 16.038 0.340293 -0.250982 -17.8101 -8572 4 46.1771 22.3609 15.1533 -8.50833 -8.1377 19.1007 -8573 4 45.4344 21.1785 15.9468 10.2139 13.0315 -4.03882 -8574 6 34.0918 26.1359 39.6112 38.0511 -8.91464 13.1738 -8575 4 33.1848 26.2338 39.3827 -25.4265 4.60567 1.8853 -8576 4 34.221 26.2032 40.5833 -12.0295 -1.62025 -11.2558 -8577 6 7.22533 36.1661 23.281 -59.3132 -5.14125 -34.652 -8578 4 7.26364 37.0581 22.9295 6.20379 9.34593 -2.3157 -8579 4 7.97006 36.0735 23.8015 59.451 -4.11437 40.0555 -8580 6 29.1637 40.7448 9.14206 -2.51826 7.72751 -13.9009 -8581 4 29.0444 40.3656 8.22324 15.9504 -2.90487 33.8878 -8582 4 29.7314 40.248 9.77766 -4.36215 -9.31282 -20.9127 -8583 6 29.3678 11.2357 1.30083 -35.1077 14.24 19.1284 -8584 4 28.4669 11.4731 0.940057 29.2946 -5.02339 11.2991 -8585 4 29.318 11.4379 2.27092 4.83193 -7.95866 -28.0539 -8586 6 30.9732 3.71267 14.0776 15.2348 -46.8383 -31.5788 -8587 4 31.4582 2.88428 14.3733 -12.5046 34.6753 7.46482 -8588 4 30.8397 3.49874 13.1133 -3.67459 15.4991 23.3176 -8589 6 29.7056 15.2804 38.2794 -11.9618 14.5562 -33.6413 -8590 4 30.2702 15.1354 39.0168 20.1567 -4.59268 23.419 -8591 4 30.0841 16.0123 37.7308 -6.59039 -15.0688 15.6005 -8592 6 36.6264 0.310111 29.1514 -5.04796 -7.83703 -2.09784 -8593 4 37.4271 0.819379 29.3706 -8.93441 4.46737 -4.0897 -8594 4 35.9914 0.856083 28.6484 15.2391 -5.29618 7.37908 -8595 6 47.6417 0.116275 23.248 13.5287 8.94531 -12.2883 -8596 4 47.0119 0.433387 23.8864 -15.3927 3.59754 12.8324 -8597 4 47.4641 41.0946 23.1357 -2.49679 -12.2922 2.24912 -8598 6 7.90637 37.1762 29.9388 8.54368 22.8184 26.8453 -8599 4 7.85301 37.2098 30.9449 3.45275 -3.37357 -41.2712 -8600 4 8.44496 37.9737 29.6897 -17.0006 -23.7003 10.0801 -8601 6 38.9296 24.2329 12.6383 15.5219 -16.6974 -22.776 -8602 4 37.9787 24.1601 12.7323 -9.9748 0.376678 1.49713 -8603 4 39.1449 23.5705 11.9215 -5.67631 22.059 20.3409 -8604 6 21.3179 26.2613 36.7933 11.7928 19.07 -1.51604 -8605 4 20.8397 25.6962 36.2015 -9.60619 -6.53459 -13.3894 -8606 4 21.5182 25.6957 37.5187 2.0605 -10.1459 21.1123 -8607 6 28.2262 23.3351 24.9913 6.08955 -0.748437 0.460504 -8608 4 28.2308 24.0016 25.6964 4.22655 -6.81745 -1.24962 -8609 4 29.0479 22.8075 25.0363 -13.73 7.51762 2.95505 -8610 6 38.3897 39.5713 14.5774 34.0997 -9.77678 18.0089 -8611 4 38.4779 38.8655 15.2987 -6.58584 29.8461 -29.0755 -8612 4 39.3026 40.0121 14.5422 -41.1029 -19.3921 -1.23505 -8613 6 26.0587 6.01626 38.1331 -7.56489 -16.2073 9.45163 -8614 4 26.364 6.92283 38.0032 14.5247 -0.467326 2.92393 -8615 4 26.7573 5.38712 38.4414 -3.391 26.9876 -7.34507 -8616 6 52.1178 17.2513 22.5128 -10.8492 5.54118 7.42996 -8617 4 52.8997 17.6733 22.1718 9.92427 15.7211 -4.0445 -8618 4 52.2219 16.3395 22.2718 -2.102 -18.0313 -4.16051 -8619 6 39.531 30.2011 31.4754 1.32431 5.33104 20.3977 -8620 4 40.1389 30.6029 32.1578 -26.1612 -12.9519 -10.6425 -8621 4 38.6407 29.9778 31.8528 28.462 12.4065 1.81878 -8622 6 19.6595 6.91666 12.7659 -14.5008 4.80913 14.0157 -8623 4 19.6887 6.47111 13.6446 7.23462 -2.42447 -18.0556 -8624 4 20.266 6.55226 12.115 5.2883 -10.9354 6.21868 -8625 6 32.4266 37.4954 40.1172 13.7501 31.88 -47.4625 -8626 4 32.7425 36.6266 39.9032 -2.48661 -20.9779 5.59445 -8627 4 32.1419 37.5817 40.9958 -11.8933 -10.3197 48.8363 -8628 6 39.7596 0.337115 6.09995 15.1421 -1.66777 24.2876 -8629 4 40.1534 1.22219 6.08152 -5.11901 -0.972083 -7.53812 -8630 4 40.1657 41.8549 6.90018 -9.37436 -2.20237 -11.3555 -8631 6 28.7751 10.1584 29.138 -2.01192 2.80513 -2.93319 -8632 4 27.8238 10.1744 29.001 -3.57801 1.81269 -4.50746 -8633 4 28.8919 9.80572 30.0274 6.34341 -2.0407 -1.56061 -8634 6 28.3442 21.074 10.6333 2.67716 -1.32955 -8.08167 -8635 4 28.7162 21.9756 10.7458 1.68682 -14.6392 -2.70928 -8636 4 28.9848 20.5267 10.1317 -8.30024 16.2649 10.4277 -8637 6 27.0693 28.6863 20.8775 28.7719 -2.37794 4.3254 -8638 4 27.7298 29.2434 21.3283 -4.93173 -3.86203 -1.8773 -8639 4 26.2334 28.9344 21.2444 -24.6691 6.36732 10.1211 -8640 6 39.6873 13.9804 33.4544 10.1398 -5.61125 10.7915 -8641 4 40.0465 13.7022 34.3167 -4.86 2.4669 -10.6871 -8642 4 38.7726 13.6755 33.4723 -5.1401 -2.85022 0.606476 -8643 6 25.4597 11.6576 34.3181 14.491 -28.0098 33.8508 -8644 4 24.8514 11.0162 34.7619 5.36553 12.2612 -15.2396 -8645 4 25.0161 12.1454 33.6493 -21.152 12.7672 -16.4478 -8646 6 27.5131 37.6326 21.427 -19.9573 -21.9997 -23.7283 -8647 4 28.2253 37.2064 20.96 8.67225 -9.05343 -17.242 -8648 4 27.9596 38.068 22.1137 20.557 20.5047 35.0331 -8649 6 30.5914 20.0695 28.6348 27.7431 -17.6396 19.2377 -8650 4 30.9836 19.3645 29.1801 11.8534 20.0629 -12.5158 -8651 4 29.6982 19.8076 28.6872 -39.6618 5.20089 -10.7407 -8652 6 42.3778 1.85684 14.9393 25.4983 -1.50621 30.9456 -8653 4 41.9471 2.41032 15.6124 -5.43016 1.03086 -4.74891 -8654 4 41.8361 1.80616 14.1675 -19.8596 2.00334 -17.6468 -8655 6 12.1616 12.5321 19.523 -14.5305 -6.69845 -4.01711 -8656 4 12.9939 12.0448 19.446 -0.641831 -5.10207 -0.17564 -8657 4 11.4028 11.9007 19.4323 17.6183 8.93718 0.635936 -8658 6 19.2173 1.21358 16.3673 12.2327 1.89672 9.92834 -8659 4 19.755 0.600796 16.911 -5.77615 9.45405 -9.5745 -8660 4 19.8129 1.9499 16.1364 -2.75311 -6.47505 -0.557351 -8661 6 9.48027 16.145 27.6887 18.4383 23.7652 -21.1678 -8662 4 9.95062 16.009 26.8224 -12.6846 -2.19341 25.2173 -8663 4 9.19893 15.3052 28.0262 -3.30777 -17.5687 0.945009 -8664 6 40.4566 26.1709 24.7821 -20.4805 41.2174 -0.532491 -8665 4 40.3628 26.7039 25.5991 10.1463 -19.7663 1.05084 -8666 4 40.0809 26.8306 24.1463 10.2053 -25.1837 1.88999 -8667 6 47.6675 17.6506 18.0225 -30.0634 41.3074 12.2788 -8668 4 48.2543 17.9981 18.7254 0.401995 -10.3127 -9.33209 -8669 4 46.9068 18.3177 18.0388 29.0716 -28.5939 -1.2112 -8670 6 36.6158 25.2629 4.18774 29.3736 28.0527 4.32129 -8671 4 36.5214 25.5758 5.09839 -16.0305 -5.04511 0.138651 -8672 4 37.2819 25.9232 3.86538 -16.6324 -17.2389 -6.3952 -8673 6 39.5728 35.3879 29.6636 12.278 22.7044 -7.26925 -8674 4 39.0499 34.5938 29.661 -5.91236 -8.06683 2.48368 -8675 4 39.3907 35.9006 30.4607 -1.7908 -9.53931 -1.38728 -8676 6 0.412001 14.6096 13.3342 2.26376 -2.5079 -14.7045 -8677 4 54.7802 15.2759 13.6175 -3.32355 6.27336 -0.974202 -8678 4 0.516441 14.0579 14.0961 4.60085 -12.9246 15.0473 -8679 6 12.196 27.3305 8.43326 10.0473 13.6833 14.0535 -8680 4 13.031 26.8669 8.51701 2.31971 -16.5604 -6.51009 -8681 4 12.4357 28.1833 8.85089 -17.0888 -3.60228 -10.1051 -8682 6 36.9057 14.8161 21.1198 30.6025 20.2317 -25.7914 -8683 4 37.0125 14.4244 21.9807 1.92342 -10.2074 20.832 -8684 4 37.7936 15.2053 20.874 -24.9082 -16.5351 5.08732 -8685 6 20.8486 4.94275 21.105 17.9022 -6.61396 -0.309651 -8686 4 20.374 5.67415 21.5228 9.17185 2.06744 3.08402 -8687 4 21.7751 4.88103 21.448 -24.8745 1.45604 -2.42669 -8688 6 36.7441 1.80601 7.63303 -8.86792 14.8212 -18.8361 -8689 4 36.3577 2.71345 7.77493 14.0998 -30.8697 16.0099 -8690 4 36.9898 1.34966 8.45182 -6.21638 14.7491 3.51078 -8691 6 12.2291 31.5076 37.4606 -20.8205 4.71929 16.9336 -8692 4 12.7789 31.2189 36.7301 -1.71439 -5.19212 -6.77065 -8693 4 11.3837 31.0118 37.4916 13.4088 3.21935 -3.86138 -8694 6 38.9875 41.6041 16.8806 -4.97036 -4.86794 -9.64455 -8695 4 39.4307 41.5716 16.0177 3.10466 0.790549 7.7281 -8696 4 39.367 0.410173 17.3903 6.57234 9.13046 2.45051 -8697 6 31.8971 27.2651 22.2536 0.475946 9.95506 -26.8482 -8698 4 31.2288 26.6192 22.5148 1.53167 3.01995 -0.700727 -8699 4 31.6701 27.5469 21.3168 1.33988 -13.0026 32.8364 -8700 6 42.7373 9.18402 25.5752 -16.5205 -8.12573 12.5156 -8701 4 42.0715 8.82875 24.9549 8.97347 3.93682 -3.18445 -8702 4 43.4726 9.55718 25.0966 9.17117 4.66181 -14.1392 -8703 6 50.9317 28.1762 25.3585 1.81467 11.9603 16.0249 -8704 4 50.4332 27.6858 24.699 -7.797 -4.30978 2.61883 -8705 4 50.6061 27.9816 26.259 1.82058 -3.16123 -16.2825 -8706 6 43.2019 19.6758 30.9261 -60.5069 12.608 18.1565 -8707 4 44.1121 19.7947 30.8273 58.227 11.7487 -4.80009 -8708 4 42.8317 20.4979 31.3452 14.2318 -14.5845 -6.94071 -8709 6 30.6579 14.0392 40.8099 -3.90856 28.8453 32.4485 -8710 4 30.2625 14.437 41.6588 6.78025 -22.1962 -33.7862 -8711 4 30.2388 13.192 40.6401 -8.31431 -9.09038 5.19898 -8712 6 20.9126 15.487 23.0255 1.81996 -1.2716 -0.577536 -8713 4 20.3529 16.1851 23.4151 9.86352 -5.06847 -1.26552 -8714 4 21.845 15.6804 23.2451 -11.0139 0.781722 1.09061 -8715 6 34.2266 0.759926 35.8266 5.91607 -35.831 36.3238 -8716 4 34.6699 1.4486 36.3596 -6.19332 -9.6922 -6.67054 -8717 4 34.0788 41.8551 36.4474 5.42693 41.8664 -30.5853 -8718 6 38.9146 36.9114 35.918 21.2173 -10.8751 17.2864 -8719 4 39.7829 37.095 36.338 -12.434 5.66027 -11.9648 -8720 4 38.7157 36.033 36.27 -5.46808 2.11761 -7.10044 -8721 6 45.1412 25.209 22.7799 -9.21588 11.7282 35.1943 -8722 4 44.1635 25.1535 22.9277 18.3683 -4.67801 -8.38153 -8723 4 45.395 24.8019 21.9606 -9.08047 -9.94082 -17.9945 -8724 6 40.6079 0.819632 35.9543 -10.1658 30.0784 -5.29357 -8725 4 40.5743 41.7978 35.9297 8.39322 -37.6139 4.80851 -8726 4 39.8853 1.04128 35.3423 10.5918 6.58535 9.58714 -8727 6 11.0481 28.354 35.0263 -7.05837 2.15472 6.15391 -8728 4 11.0065 27.7661 35.7937 6.20016 -1.50115 -1.31869 -8729 4 10.2774 28.923 35.1598 -2.00076 2.29074 -4.05614 -8730 6 20.214 13.5993 35.8619 28.0429 -16.4719 23.5579 -8731 4 19.4963 13.9327 35.3857 -45.1468 12.1599 -23.9045 -8732 4 20.9404 14.0304 35.4284 21.7873 4.64258 -6.99651 -8733 6 39.6259 5.13927 1.77541 6.3837 10.5905 23.0009 -8734 4 38.815 4.76887 1.43754 -8.89155 -4.8304 -7.9643 -8735 4 40.2998 5.10051 1.09544 5.70124 1.55861 -13.0764 -8736 6 30.2644 30.8765 32.4376 2.45351 13.5189 11.7538 -8737 4 29.6638 31.1848 33.1457 1.37952 -7.29152 -6.97913 -8738 4 29.9065 30.0722 32.0512 -6.5155 -7.29863 -0.0927806 -8739 6 14.5561 10.991 22.8667 10.081 16.7623 43.7388 -8740 4 15.1677 11.6459 23.3133 -13.9792 -18.4015 -26.7579 -8741 4 13.9431 10.829 23.6181 3.59137 -7.6484 -17.8174 -8742 6 20.7554 13.9367 3.0184 -22.7431 -13.2276 -14.851 -8743 4 19.9027 13.7405 2.57467 24.082 -4.954 3.77469 -8744 4 20.4786 14.7044 3.49738 5.42185 19.6619 18.2233 -8745 6 41.2999 4.28373 12.6115 -5.11846 11.2121 16.06 -8746 4 40.5902 3.66826 12.7964 -5.45414 -3.74116 2.1628 -8747 4 41.646 4.04628 11.766 6.8814 -9.70345 -22.8074 -8748 6 10.8486 24.7151 21.7079 -22.0181 20.7635 -2.99902 -8749 4 10.06 25.055 21.1824 26.1755 -20.3138 8.68391 -8750 4 11.196 23.8735 21.3742 -8.74412 -0.217035 -8.2032 -8751 6 53.5851 20.8962 34.3615 -20.5776 4.99959 -7.54911 -8752 4 54.5312 20.9399 34.3174 23.7346 3.60458 -0.717784 -8753 4 53.3344 20.0378 34.731 7.46747 5.54606 -4.26157 -8754 6 14.8822 4.84805 30.4483 -9.71325 -6.00753 -19.6684 -8755 4 14.771 4.94284 29.4789 1.77408 0.90497 14.7496 -8756 4 14.5561 3.94513 30.5986 4.49673 6.24836 5.5759 -8757 6 48.9024 37.1196 13.1149 -36.5603 24.8322 -14.1851 -8758 4 47.9606 37.2057 13.4129 22.1922 -3.12109 -3.19476 -8759 4 49.2987 36.4589 13.6532 13.3268 -16.5999 12.901 -8760 6 26.8059 19.3169 7.54434 -4.26945 -4.42367 7.83904 -8761 4 27.1766 18.4867 7.22339 -3.92405 -4.32352 -1.07463 -8762 4 27.3968 19.9842 7.20607 8.782 12.6164 -5.40832 -8763 6 17.6305 11.9358 39.0864 -20.6439 9.19078 16.9487 -8764 4 18.5077 11.609 39.0209 28.8526 -12.5757 -8.06323 -8765 4 17.5232 12.1203 40.0373 -6.81014 1.23205 -8.73836 -8766 6 49.927 14.591 8.61416 15.5742 -26.1486 -8.96269 -8767 4 49.2009 13.9524 8.72368 2.87529 10.9098 3.94828 -8768 4 49.6414 15.4659 8.85563 -10.1676 20.5637 7.32703 -8769 6 32.3582 34.9735 31.5167 -0.414276 11.4895 24.1707 -8770 4 32.1283 34.3825 30.8126 -1.81559 -4.89127 -12.898 -8771 4 32.4479 35.8663 31.1601 -0.97656 -3.19104 -3.1743 -8772 6 11.821 22.2226 21.3194 1.12988 -20.2292 -31.7924 -8773 4 12.2035 21.6949 20.5593 -17.646 16.3031 19.3587 -8774 4 12.5076 22.1609 21.967 14.4856 1.86701 17.8995 -8775 6 33.8479 9.95925 13.6297 5.85555 4.94861 0.641841 -8776 4 32.9412 9.60258 13.4965 20.4646 2.44791 -13.0803 -8777 4 34.46 9.81143 12.8638 -25.0852 -4.3509 9.75457 -8778 6 25.5216 36.3896 1.4985 -3.83916 -1.90754 -5.44184 -8779 4 26.1733 36.851 0.947779 -3.43756 3.58217 3.68691 -8780 4 24.6678 36.8514 1.38848 10.8858 -3.23471 -1.95008 -8781 6 26.2654 10.5456 9.75524 -44.5011 8.64206 25.1655 -8782 4 25.6084 11.269 9.60979 18.788 -4.56637 -6.88642 -8783 4 25.8198 10.0845 10.5139 21.0346 7.54764 -16.1236 -8784 6 25.0247 0.792222 40.9035 16.6629 9.7536 -9.8108 -8785 4 25.2766 0.410293 40.0414 -7.0744 -0.853038 7.71488 -8786 4 25.4535 1.67289 40.8914 -6.39875 -10.0211 5.33714 -8787 6 46.2514 3.92331 24.811 2.29787 -10.4124 3.565 -8788 4 46.4476 4.07649 23.8793 1.84574 -7.0337 -1.43198 -8789 4 46.0806 2.96577 24.928 -3.00701 8.9366 -8.52535 -8790 6 21.593 13.605 29.211 2.46069 1.87638 12.7155 -8791 4 21.5518 14.2847 29.9136 -0.977025 -6.07097 -8.18011 -8792 4 21.3035 14.062 28.4178 -1.02829 3.62716 -1.29843 -8793 6 36.772 38.3747 0.364057 -13.57 -14.6746 -5.92565 -8794 4 36.4241 39.1227 0.863015 -2.10343 5.30459 -0.282121 -8795 4 36.0255 37.7419 0.250491 13.2024 11.0478 3.68109 -8796 6 19.3024 17.6377 24.0664 34.4056 30.1631 -22.0465 -8797 4 18.4191 17.3498 24.1437 -40.9446 -15.7866 5.54764 -8798 4 19.2946 18.2748 23.3003 0.347271 -14.2409 17.5238 -8799 6 23.1729 12.6936 3.50527 -23.4203 -1.67393 -9.32385 -8800 4 22.2599 12.987 3.28408 10.1497 2.83055 6.60862 -8801 4 23.2366 11.8468 3.05081 2.04707 -0.882582 2.79058 -8802 6 37.8929 8.88926 35.4532 -15.1513 -19.5409 -35.7954 -8803 4 38.8496 8.85033 35.2802 -3.80753 -1.00094 -0.145651 -8804 4 37.4409 8.32345 34.738 24.7998 24.8105 28.8968 -8805 6 14.3214 15.124 36.1936 10.1777 -8.45579 -11.337 -8806 4 15.1189 15.6285 36.3983 0.383997 -0.909139 3.4786 -8807 4 13.728 15.2114 36.9249 -8.84751 6.7001 14.2991 -8808 6 35.0764 0.951221 33.027 4.39995 -0.747562 -23.3066 -8809 4 34.9707 1.92678 33.0471 -0.901583 -14.825 16.9845 -8810 4 34.929 0.489106 33.8671 -4.79444 18.9729 2.67887 -8811 6 50.9368 0.508345 17.9996 -16.1068 -2.11236 -10.8013 -8812 4 50.7363 1.3993 17.6607 6.59543 -7.82408 5.75367 -8813 4 50.2126 41.8571 17.6452 15.113 5.01242 7.08044 -8814 6 26.2276 30.5707 0.943679 2.98972 25.4521 29.679 -8815 4 26.9747 31.0717 1.30878 -11.5718 -5.07384 -0.177367 -8816 4 26.5685 30.1289 0.190254 7.28539 -15.5247 -23.6744 -8817 6 18.5631 38.2963 4.56281 15.0547 -0.00169581 -1.07608 -8818 4 17.6313 38.4808 4.44067 -9.04909 6.52025 -3.84653 -8819 4 19.0145 38.7079 3.79419 -7.75189 -5.39823 9.30868 -8820 6 31.1327 5.08368 4.10816 20.0095 -18.3558 -6.33253 -8821 4 31.8391 4.51927 4.54922 -26.0459 18.0586 -17.7145 -8822 4 31.2112 4.96997 3.12633 -1.20575 2.29654 19.098 -8823 6 26.4386 21.9021 1.48262 11.6176 -12.3641 -2.34526 -8824 4 26.4119 22.77 1.11333 -7.24657 26.8604 -8.21156 -8825 4 27.3591 21.6321 1.37052 -1.3799 -4.61827 0.12427 -8826 6 39.218 11.6975 22.8013 10.5737 17.0434 4.86912 -8827 4 39.8837 11.6898 23.5135 -8.12783 -9.21376 -3.17514 -8828 4 38.7576 10.8611 22.7762 -0.316566 -9.51531 5.7902 -8829 6 13.6104 36.3454 30.6448 12.2201 31.8005 15.4331 -8830 4 13.9411 37.0787 31.1944 -5.64032 -6.12374 -20.8561 -8831 4 13.4819 35.6769 31.3099 -5.82879 -19.5305 -1.97286 -8832 6 50.5737 9.8729 9.34449 -28.5439 -15.8542 -0.594603 -8833 4 49.6941 9.5296 9.68217 24.5077 10.0039 -8.16891 -8834 4 50.7802 10.6382 9.87905 1.56032 8.49656 8.37591 -8835 6 49.6568 40.2957 22.5808 3.13406 -4.17489 -1.45496 -8836 4 49.9643 39.4131 22.2832 -6.04563 10.523 5.74674 -8837 4 49.4657 40.2311 23.537 6.08697 -6.10842 -7.72776 -8838 6 7.19984 41.3227 28.8903 -1.52952 20.6044 28.9443 -8839 4 7.18166 41.5789 29.8666 2.82963 -8.74683 -37.3978 -8840 4 7.33954 0.237732 28.3754 1.09714 -11.2116 9.436 -8841 6 13.0357 18.018 25.3358 19.442 16.9905 44.3108 -8842 4 13.6166 18.1186 24.5548 -1.12298 4.17303 17.3747 -8843 4 13.5323 18.3306 26.2146 -21.9746 -20.4015 -59.5043 -8844 6 50.052 19.589 2.43093 38.9512 -4.48133 -22.8803 -8845 4 50.7424 19.2598 1.79532 -23.4729 1.49397 14.1456 -8846 4 50.5528 20.298 2.8491 -7.87613 8.00017 8.65361 -8847 6 28.349 40.9814 24.5177 14.9096 -9.01222 -0.77751 -8848 4 28.8235 40.5955 23.7606 -4.31864 4.07524 4.80921 -8849 4 27.7156 41.5877 24.1507 -14.6867 11.3415 -7.76415 -8850 6 19.4129 5.36023 29.5381 -15.1481 -17.3665 11.3948 -8851 4 20.1134 5.96028 29.2689 3.1753 8.4576 0.913483 -8852 4 18.7407 5.8353 30.064 8.44892 1.72514 -6.85652 -8853 6 35.3149 40.1584 22.2743 -5.4761 3.67764 -22.0922 -8854 4 35.6772 39.8166 23.0859 3.70556 0.822605 11.3301 -8855 4 35.3088 41.1243 22.2924 6.6179 -0.993945 11.5959 -8856 6 16.1846 33.7767 9.75922 -0.358556 8.53088 17.0233 -8857 4 15.9516 33.2005 9.03859 1.48669 -13.8429 -11.0903 -8858 4 15.6081 34.5411 9.70154 -4.21994 3.45608 -1.0308 -8859 6 17.3638 40.6569 20.2187 0.0478101 13.797 12.0053 -8860 4 17.2553 39.7868 20.6094 -1.96745 -8.64858 -4.42208 -8861 4 17.5346 41.2369 20.9867 0.609446 0.00823871 -10.958 -8862 6 20.5168 9.71855 9.57392 23.3053 8.23996 -15.5036 -8863 4 21.1612 10.0129 10.2371 -5.46071 -1.58749 -5.90152 -8864 4 19.8092 9.36498 10.0856 -20.4585 -11.5711 12.7624 -8865 6 47.4431 20.1927 21.3797 46.3705 -23.5901 12.8176 -8866 4 48.2534 19.5912 21.2825 -32.1103 24.8918 7.30718 -8867 4 46.9863 20.0806 20.5604 -17.463 -0.0836882 -22.1962 -8868 6 38.4119 40.7863 37.8131 4.58972 -16.3007 -8.86139 -8869 4 38.2015 41.716 37.7675 -2.07213 19.1933 -0.538509 -8870 4 38.1163 40.4897 38.6817 -2.89344 0.451293 5.51523 -8871 6 4.78246 1.95264 13.1142 -0.962758 -11.3299 -4.56483 -8872 4 4.86308 1.24617 12.4504 1.09441 11.0888 1.2667 -8873 4 4.58181 1.48453 13.9266 -0.88642 0.622503 9.15822 -8874 6 46.8366 29.0044 2.17213 -21.5573 10.7483 2.0879 -8875 4 46.5703 29.0979 3.11526 14.9241 -10.138 -17.8178 -8876 4 47.6533 28.5191 2.04264 7.39387 -6.09514 13.7966 -8877 6 37.4332 26.1628 25.6457 0.476866 -1.57884 -3.35254 -8878 4 37.1432 25.5044 26.2761 -1.46501 -6.7424 3.65975 -8879 4 36.6379 26.5951 25.3475 -3.92424 6.80267 -0.609098 -8880 6 27.3215 4.19863 19.437 6.03131 -5.89417 1.59018 -8881 4 28.0693 4.5088 18.8685 -19.6633 0.0824503 4.70742 -8882 4 26.4692 4.57526 19.1444 8.48727 3.90116 -6.43998 -8883 6 29.5816 35.1763 32.6702 11.3433 -15.1984 -13.0035 -8884 4 29.498 34.4257 32.0309 -0.34209 19.1564 15.9908 -8885 4 30.487 35.489 32.5363 -2.16348 -1.10322 -0.755163 -8886 6 51.6039 27.3804 34.6228 -16.2846 20.7721 3.47149 -8887 4 51.9118 26.5342 34.8842 8.46829 -31.6815 14.0056 -8888 4 52.043 27.5552 33.7939 4.07896 7.882 -12.2594 -8889 6 26.213 15.718 22.6983 4.45652 -13.2698 4.19624 -8890 4 25.9644 16.5706 22.3629 -2.74203 26.12 0.0562263 -8891 4 25.9462 15.1046 22.0171 -4.99078 -11.3651 -6.14484 -8892 6 36.1284 41.1872 15.4686 -15.9675 5.34592 -0.326298 -8893 4 35.5872 40.4009 15.2728 11.0637 0.363161 -0.898578 -8894 4 37.0593 40.962 15.4319 4.98109 -12.2962 -3.97184 -8895 6 18.4605 8.81439 11.2163 9.85092 25.9028 -2.05591 -8896 4 18.8222 8.21565 11.8732 -2.65799 -9.87079 3.83174 -8897 4 17.6938 8.4288 10.8111 -9.58752 -11.4871 -1.05984 -8898 6 30.2054 21.3176 23.2008 0.0321998 2.06754 0.100272 -8899 4 29.9991 22.2239 22.9456 -2.76699 -3.99559 -1.97847 -8900 4 29.5697 20.7243 22.7648 2.21136 7.68347 0.454199 -8901 6 22.7376 2.20942 34.8415 -7.06988 -25.8748 21.345 -8902 4 22.3263 1.32441 34.7915 6.81547 13.2405 5.99888 -8903 4 22.6443 2.51876 33.959 0.748808 17.6695 -28.972 -8904 6 12.6779 2.74229 12.3423 -3.02369 13.9186 -14.8572 -8905 4 12.6684 3.63953 11.9163 1.20981 -22.4864 12.4813 -8906 4 13.1874 2.20366 11.7175 -0.841633 0.53426 4.77071 -8907 6 24.0891 30.0714 14.5767 2.26717 -13.4561 -11.586 -8908 4 23.8674 30.8343 15.1637 -15.8173 -12.4528 -15.4046 -8909 4 23.3482 29.6562 14.0436 11.1594 27.3113 22.4963 -8910 6 0.0169515 27.9037 22.8558 -22.9231 2.02358 -4.19556 -8911 4 54.5653 28.3586 23.5905 7.88497 -1.22395 1.09473 -8912 4 54.2173 27.7016 22.3138 13.4725 -1.40758 1.11908 -8913 6 12.3768 4.48401 25.8984 -1.01368 1.72138 -1.86924 -8914 4 11.999 5.34556 25.8124 1.61778 23.022 -11.6285 -8915 4 11.6412 4.07623 26.3496 -0.520107 -24.5543 7.98643 -8916 6 50.6552 14.4595 5.90563 -9.7075 2.6569 37.2621 -8917 4 51.421 15.0215 5.71422 1.2699 0.536098 -2.53407 -8918 4 50.4862 14.5526 6.9139 5.60038 -4.97296 -46.1729 -8919 6 52.566 22.8545 20.1304 -1.0263 1.56712 -17.1158 -8920 4 52.8493 23.3468 20.8979 1.30497 -0.175929 17.7779 -8921 4 52.7622 23.494 19.4302 -3.4332 -7.01119 -2.14697 -8922 6 43.5747 16.5432 12.8706 26.1082 -6.15301 -20.1459 -8923 4 44.3581 16.1075 12.4177 -27.2623 16.7463 17.9516 -8924 4 42.8105 16.3628 12.3102 -5.85283 0.59737 -2.51971 -8925 6 15.9643 16.7491 40.5889 4.71604 31.6512 -1.38133 -8926 4 16.4157 17.2981 39.8953 -10.7397 -16.8436 16.4649 -8927 4 15.6568 17.4119 41.253 8.12177 -13.8769 -14.2686 -8928 6 23.4093 18.8548 23.8539 -16.419 -4.21219 2.12821 -8929 4 23.4427 19.3457 24.6888 0.296298 -1.81048 -2.30579 -8930 4 22.5005 18.9913 23.5305 9.65682 -2.29273 2.24785 -8931 6 46.4286 3.27372 31.8783 1.50761 -1.36157 -5.63512 -8932 4 45.559 3.26328 31.468 -2.27736 -0.687336 -10.0334 -8933 4 46.2409 3.35124 32.8099 7.04458 2.11131 4.36323 -8934 6 43.404 41.0501 12.2894 -4.74196 -21.563 6.60959 -8935 4 43.6943 41.7945 12.8025 5.82787 10.392 6.16968 -8936 4 43.4921 41.2918 11.3656 -0.276957 5.00436 -10.4807 -8937 6 7.4944 32.479 29.5886 4.16519 42.7458 -9.72808 -8938 4 8.11522 31.7905 29.7504 15.4265 -22.4366 1.70525 -8939 4 8.06583 33.2868 29.4339 -18.9062 -19.2919 1.43274 -8940 6 4.77786 31.6555 22.5097 8.01353 -0.237295 6.09653 -8941 4 5.36252 32.2279 23.0433 -12.0801 1.27555 -9.50519 -8942 4 4.10079 32.1892 22.0697 5.55495 3.82082 5.5049 -8943 6 48.8707 26.8644 2.67473 3.24755 -50.1854 9.90243 -8944 4 49.7841 26.6767 3.05593 -33.5394 4.93648 -17.7122 -8945 4 48.3402 25.9967 2.74374 27.3415 43.0547 -3.91521 -8946 6 35.3704 23.2724 21.6151 -20.572 -8.60634 18.7236 -8947 4 36.1531 22.7653 21.8467 10.3528 0.763668 -1.9928 -8948 4 35.5272 23.8633 20.8878 14.153 10.3741 -19.8739 -8949 6 9.81162 37.7752 27.3066 -7.93747 -1.88745 -15.4111 -8950 4 9.56608 38.5967 27.7736 11.3364 -13.9943 4.65066 -8951 4 10.53 37.2723 27.7168 -2.00951 8.75096 9.6206 -8952 6 6.95784 10.9804 26.0002 -14.8513 -9.26658 -13.6642 -8953 4 6.43708 10.2284 25.6287 17.7452 16.2397 9.86134 -8954 4 7.32481 10.7062 26.8445 2.87033 -7.35616 11.341 -8955 6 15.9925 34.488 38.9165 -7.91378 13.4212 -4.2482 -8956 4 16.1125 33.5888 38.5756 -0.423195 -0.537141 7.5048 -8957 4 15.8451 34.497 39.8859 4.12272 -10.609 -16.5735 -8958 6 24.136 17.3087 36.1669 -1.30362 -38.1211 0.134245 -8959 4 24.6388 17.5417 36.9612 2.54889 -4.89456 5.81445 -8960 4 24.0565 16.298 36.169 6.29988 31.3296 1.89661 -8961 6 29.9661 19.0481 5.63552 -3.51045 -24.0694 26.081 -8962 4 30.059 18.4844 6.44318 1.40084 7.89656 -22.1005 -8963 4 29.4651 19.7932 5.9612 -6.50009 17.0844 0.645364 -8964 6 41.2323 14.2118 25.8708 0.538972 29.9242 -13.4546 -8965 4 41.1167 15.1135 25.4912 3.21098 -20.1981 4.76589 -8966 4 41.3237 14.3734 26.8138 2.01946 -2.10135 6.77926 -8967 6 30.5977 17.7991 37.3648 -2.09385 13.2702 -7.29075 -8968 4 30.1274 18.3693 36.6865 13.7219 -8.47854 26.2153 -8969 4 30.6897 18.2674 38.2325 -7.09621 1.58925 -18.9017 -8970 6 36.2622 35.7606 28.8616 -21.9344 -15.8478 13.9239 -8971 4 36.666 34.9659 29.2737 0.470987 14.2463 -5.72758 -8972 4 36.9609 36.34 28.5862 17.8584 7.52692 -3.58957 -8973 6 0.186361 37.881 20.3783 -19.4052 1.06805 -13.5296 -8974 4 0.625244 37.258 20.9754 1.43275 1.23053 -1.08677 -8975 4 54.3963 37.4077 20.0073 13.2242 8.68111 6.51083 -8976 6 49.5157 39.5849 25.2719 1.34086 -27.0873 28.6785 -8977 4 49.1738 39.8396 26.1677 9.83442 -4.23573 -27.15 -8978 4 49.8309 38.6394 25.3482 -11.1501 31.2987 0.525887 -8979 6 21.6501 10.2052 29.3652 1.38747 -32.8599 -17.8213 -8980 4 21.4815 11.1062 29.1158 -2.57329 19.5966 11.1399 -8981 4 21.7962 10.0736 30.3036 1.32123 13.0863 10.38 -8982 6 36.4484 30.062 0.133613 20.0221 49.2239 1.07318 -8983 4 36.3691 29.4748 41.3122 -8.72629 -28.1564 -18.1683 -8984 4 36.9877 30.812 41.6437 -16.8233 -22.5363 23.3328 -8985 6 35.2366 23.3806 39.1473 20.2218 -67.2813 -35.6269 -8986 4 34.8925 23.3776 38.2436 -2.85003 -5.00903 7.3464 -8987 4 34.9678 24.1769 39.4749 -24.7984 75.1446 29.9953 -8988 6 25.4958 17.6356 38.7131 -1.05403 5.23051 -13.5311 -8989 4 26.2557 17.1099 38.9745 11.6052 -6.82876 2.03202 -8990 4 25.6896 18.4914 39.1039 0.551448 5.55093 4.31103 -8991 6 32.6851 1.71412 15.3757 -17.1832 -26.0249 32.2484 -8992 4 32.9133 1.90091 16.3255 -0.281287 1.06348 -22.8896 -8993 4 32.1369 0.878474 15.451 14.5551 28.5253 -7.92953 -8994 6 2.74577 26.2334 40.164 -3.83079 -17.2464 -24.8373 -8995 4 2.52975 26.8073 40.8689 -10.0885 25.811 23.4985 -8996 4 3.46379 25.6906 40.4857 13.7859 -11.3271 -3.22577 -8997 6 25.4247 39.5803 6.65235 -3.20662 25.1889 -29.4644 -8998 4 26.0108 39.0547 7.19361 -10.0861 -10.9475 13.3666 -8999 4 24.4797 39.508 6.87242 11.3389 -11.2764 10.0712 -9000 6 3.89558 2.45526 21.1915 20.3615 -74.5786 -16.468 -9001 4 3.45835 1.54866 20.9342 19.9424 46.4596 11.9477 -9002 4 3.20863 3.06758 21.3193 -35.5841 29.5388 2.2294 -9003 6 19.428 35.9937 6.17834 -35.0483 8.79483 10.2733 -9004 4 18.6638 35.8781 6.77432 14.6839 -5.07873 0.0324743 -9005 4 19.0495 36.6291 5.56439 9.71061 8.85688 -10.7695 -9006 6 53.6717 10.8593 34.7958 -7.0633 -31.3632 -8.45381 -9007 4 53.6341 10.4895 35.6991 7.39736 18.8685 -12.2464 -9008 4 53.8829 11.7827 34.7263 4.03482 19.5096 16.0301 -9009 6 51.2684 14.0949 34.672 -8.65676 -1.63762 -26.9588 -9010 4 50.7715 13.5641 33.9816 13.3581 12.906 22.4054 -9011 4 51.0369 13.7812 35.5532 -5.90867 -9.66849 3.74112 -9012 6 14.4369 40.0234 28.032 -17.7583 12.3896 33.8878 -9013 4 13.8707 39.2432 27.9284 6.73847 -3.79593 -5.43806 -9014 4 14.0697 40.4885 28.8439 14.5888 -10.3946 -25.5694 -9015 6 36.0586 40.8581 1.30985 34.3129 5.11816 -1.28261 -9016 4 35.3876 41.022 1.96214 -5.4524 5.11716 12.4526 -9017 4 36.8901 41.3246 1.61712 -30.5352 -10.0787 -2.88322 -9018 6 32.5955 21.8673 9.61487 11.2903 3.47268 22.8686 -9019 4 32.2562 21.1899 9.03409 -3.19899 -6.31213 -16.1683 -9020 4 32.8032 22.6511 9.09762 -2.66985 0.307575 -11.8305 -9021 6 53.7554 11.4583 10.0657 12.5408 -15.0223 -21.3323 -9022 4 54.7025 11.5478 10.261 -4.15933 2.55001 3.12883 -9023 4 53.7605 10.7769 9.36125 -9.51558 7.63224 9.70748 -9024 6 25.4365 2.06658 35.0039 -16.8474 18.4627 -14.151 -9025 4 25.5892 2.94197 34.5728 -1.09755 -16.5277 9.12484 -9026 4 24.4603 2.05675 35.1439 15.8828 -2.54758 -2.86629 -9027 6 38.4258 16.3759 27.0837 10.3035 -3.82582 33.4754 -9028 4 38.4229 16.0362 28.0039 4.2105 -6.34073 -14.2668 -9029 4 38.1536 17.2766 27.2341 -1.96409 14.1736 -9.55492 -9030 6 11.9898 11.8134 38.076 -13.826 -2.82892 7.4824 -9031 4 12.2944 12.4411 38.7385 15.2198 2.85174 -2.31876 -9032 4 11.0532 11.721 38.3132 2.05768 -5.32701 -10.6008 -9033 6 21.1746 40.7334 25.8979 40.4357 -13.6237 -24.6728 -9034 4 20.6698 41.4315 25.4918 -16.6357 14.348 -0.996217 -9035 4 20.789 40.494 26.7242 -19.3448 -1.94923 24.9485 -9036 6 5.46053 31.2633 28.1043 10.2831 7.82506 0.3012 -9037 4 4.85681 31.7249 27.5011 4.53193 2.9664 -2.03256 -9038 4 6.18919 31.875 28.3487 -9.19227 -4.78386 -2.03476 -9039 6 38.5722 10.4288 26.6273 1.75688 -6.42268 2.69181 -9040 4 39.2722 10.957 26.2192 0.13713 -2.38088 1.965 -9041 4 38.9883 9.93745 27.351 -0.726559 6.62326 -4.692 -9042 6 34.5654 22.2334 5.77474 -10.6824 6.04198 20.2303 -9043 4 33.6505 22.4646 6.03122 6.34024 -5.77168 -8.80249 -9044 4 35.1097 22.5906 6.49609 1.67963 -6.25138 -9.01327 -9045 6 19.5088 23.4111 8.91157 10.1707 -16.3121 14.7533 -9046 4 19.7449 23.1021 9.7973 -5.16612 6.6008 -0.0119594 -9047 4 19.9964 22.8054 8.35541 -0.106246 2.40248 -11.9056 -9048 6 19.7526 39.1673 18.9392 3.41392 2.41259 -7.44399 -9049 4 20.3112 38.9942 19.7162 -9.66179 4.90282 -1.08801 -9050 4 18.9888 39.695 19.2431 8.6955 -6.10904 -0.220035 -9051 6 19.0066 16.6479 37.8897 24.9266 -16.0788 2.00499 -9052 4 18.1904 16.5622 37.4269 -20.8911 -0.0800444 -12.5516 -9053 4 18.858 17.3198 38.5387 -2.83386 13.0664 11.2213 -9054 6 46.1457 18.3015 34.4662 -13.7163 3.02283 10.6817 -9055 4 46.1788 17.7584 33.6837 2.50627 -7.36872 -12.652 -9056 4 45.2295 18.6352 34.4793 7.83367 -3.11582 0.242547 -9057 6 37.6724 4.92727 10.6572 20.6306 -0.498941 -29.5329 -9058 4 38.5268 5.23995 10.2493 -20.9001 -6.48587 16.5696 -9059 4 37.1025 4.69637 9.88262 10.9132 7.05613 26.3995 -9060 6 51.9879 36.0003 6.84307 -0.0349375 1.28893 10.7684 -9061 4 52.0937 36.793 6.30051 2.19835 -5.62517 4.5242 -9062 4 52.7425 36.0295 7.48232 -7.26034 2.01661 -20.7899 -9063 6 26.6747 12.3215 0.993928 -15.5873 -26.456 -19.7503 -9064 4 26.4829 12.3908 1.92985 -0.4811 3.80705 11.7504 -9065 4 26.1241 11.5295 0.732228 15.7893 19.669 4.48242 -9066 6 51.344 35.7707 13.5244 -1.45768 15.8539 -2.86245 -9067 4 51.4515 36.3837 12.7824 1.55721 2.40741 1.90229 -9068 4 51.4783 34.9191 13.1366 6.57206 -21.9808 -6.55402 -9069 6 1.98876 3.63996 24.5779 3.53339 50.093 -23.5227 -9070 4 1.66274 3.05681 25.2088 -14.7773 -39.8355 33.4132 -9071 4 1.68527 4.50485 24.9411 8.95614 -12.6616 -11.2736 -9072 6 33.5242 15.2767 16.4494 0.0755523 4.59339 -41.038 -9073 4 33.5553 15.5138 15.4787 -3.36737 -9.15609 28.4742 -9074 4 33.81 16.089 16.8707 2.78154 5.67933 12.8052 -9075 6 10.7376 26.5972 37.3568 -53.543 46.6204 -3.13137 -9076 4 10.2745 27.0143 38.1249 4.48347 -4.84659 -12.5134 -9077 4 11.4659 26.2171 37.7527 59.8403 -33.1666 26.4091 -9078 6 39.618 8.36935 32.0025 -18.1555 9.41152 20.5333 -9079 4 39.1948 8.91554 32.6893 14.8148 -9.04413 -3.7523 -9080 4 39.059 8.55692 31.2545 -3.75745 -0.899113 -17.0741 -9081 6 48.8678 24.2325 11.5968 8.56011 -30.9839 -7.0275 -9082 4 49.2355 23.3258 11.4382 -10.5357 21.2684 5.64902 -9083 4 49.6052 24.6956 12.0119 -1.11745 3.30341 0.0123828 -9084 6 15.7966 8.52145 22.5402 1.04041 9.04678 1.57429 -9085 4 15.9271 8.56462 21.5825 -0.708828 -3.15413 5.43528 -9086 4 15.5351 9.42629 22.7739 -0.982858 -3.13072 -0.606507 -9087 6 16.9647 23.5461 7.94634 -33.4976 4.63454 -7.56842 -9088 4 17.0449 23.8842 7.03772 17.2153 -3.19264 11.7182 -9089 4 17.7681 23.4723 8.45101 25.4501 5.7081 -7.03081 -9090 6 42.4788 26.856 6.32162 3.09129 16.6976 -8.96027 -9091 4 41.8509 27.5547 6.55233 4.05081 -5.7053 1.31186 -9092 4 43.1337 27.3683 5.79469 -5.76138 -9.42264 4.17624 -9093 6 36.7899 4.80361 30.039 -6.11534 9.52442 2.68488 -9094 4 37.0233 4.89717 30.9689 4.03122 4.23205 -0.240484 -9095 4 36.2783 4.00567 29.9694 -7.15291 -10.8132 -0.980928 -9096 6 45.6188 11.6101 3.31184 17.0103 13.4398 12.4748 -9097 4 45.8378 10.6807 3.43524 1.11174 -8.0511 2.33471 -9098 4 46.2756 12.0957 3.86714 -12.3909 -9.3108 -12.4209 -9099 6 24.8953 36.3829 21.2888 -10.2051 -4.79955 -3.81503 -9100 4 24.4947 36.4635 22.1668 10.8854 5.06826 1.45383 -9101 4 25.816 36.6689 21.3407 0.621807 2.11968 6.76072 -9102 6 31.8152 24.7333 2.44905 16.2387 18.0677 -0.666362 -9103 4 31.5926 23.846 2.71622 -2.49338 -12.6998 4.18613 -9104 4 32.794 24.7683 2.43834 -16.3068 -2.39725 -1.0987 -9105 6 24.1315 21.9864 37.2328 -11.9778 41.7246 15.7453 -9106 4 24.1531 22.9879 37.1682 1.73438 -35.6656 2.36813 -9107 4 24.6319 21.6756 36.4808 8.45953 -1.72708 -12.6617 -9108 6 37.1993 11.5451 15.0492 16.5469 7.10484 -0.527568 -9109 4 37.9299 11.7412 15.6355 19.6925 -10.3737 -3.43176 -9110 4 36.5282 11.9944 15.5291 -36.4248 10.8574 4.75341 -9111 6 36.4804 20.3298 41.7865 -14.7619 -38.0306 11.4639 -9112 4 36.2972 19.4996 41.306 -2.7681 3.32899 7.9346 -9113 4 36.9128 20.8369 41.1399 19.1888 26.5648 -23.5244 -9114 6 32.0378 37.9251 32.6621 -20.5074 -27.3147 -8.21436 -9115 4 32.5159 38.6908 32.9558 4.48721 20.2349 -0.22713 -9116 4 31.3298 38.1855 32.0457 8.6638 5.37323 8.26506 -9117 6 12.0353 39.9275 22.5179 -19.9222 21.97 13.043 -9118 4 12.3148 40.8142 22.1582 -9.65836 -22.9721 12.3921 -9119 4 11.2968 40.0749 23.1753 26.4497 -1.81786 -22.4595 -9120 6 26.3421 1.33641 19.2861 18.8224 -12.0939 15.9617 -9121 4 26.8564 0.711595 19.8557 -14.3211 16.2919 -14.6989 -9122 4 26.7977 2.18849 19.3545 -2.53714 -0.144297 -3.51109 -9123 6 5.91333 14.3058 5.68279 5.58536 -17.6781 -26.1831 -9124 4 6.35226 14.1008 4.80839 -10.2521 5.5819 21.3359 -9125 4 5.1498 13.7016 5.72209 7.95548 1.62414 0.442017 -9126 6 13.3681 23.0924 19.1542 -7.87238 10.4677 13.234 -9127 4 14.1204 22.8148 18.6592 15.6827 -8.39443 -13.4152 -9128 4 13.7622 23.5769 19.9007 -5.90355 -3.89356 -3.96922 -9129 6 23.3981 15.0775 9.7431 -16.2896 3.15659 0.0853289 -9130 4 22.5416 14.6758 9.94236 4.38356 -3.66538 1.71341 -9131 4 23.1926 15.7004 9.03099 5.43777 4.93098 -2.67512 -9132 6 49.5886 13.8369 18.4468 -1.57371 0.160736 10.1606 -9133 4 48.8725 13.4353 17.9701 -17.3578 -11.6866 0.338485 -9134 4 50.0711 14.2256 17.7358 20.2332 17.1818 -14.445 -9135 6 41.7455 5.66741 41.8995 19.0031 1.14603 7.86728 -9136 4 42.5946 5.93333 0.438032 -19.5636 -6.95293 -12.6597 -9137 4 41.9891 5.05837 41.1762 -2.65724 5.24908 4.18535 -9138 6 17.2511 35.5417 2.55548 5.2045 0.397579 1.12894 -9139 4 18.2067 35.619 2.48098 6.39755 9.05508 3.07921 -9140 4 17.0886 34.6316 2.34229 -4.27489 -11.2961 -3.02567 -9141 6 49.7041 19.8589 40.2412 43.8428 -27.8149 3.09893 -9142 4 49.318 19.0163 40.5437 -5.31641 8.5833 -2.14336 -9143 4 50.6864 19.6533 40.2493 -27.6084 12.6334 -3.24012 -9144 6 38.3071 5.82731 32.0534 -20.9946 -3.84451 12.3853 -9145 4 37.8352 6.48986 32.6009 6.6943 -7.79079 -6.23381 -9146 4 39.2094 6.1245 32.003 13.4939 6.60324 0.292563 -9147 6 16.2694 6.84865 34.0054 -5.49782 1.82896 8.85162 -9148 4 16.5828 6.71308 33.1028 9.77351 -3.29618 -0.21352 -9149 4 16.9894 6.61948 34.6288 -2.86373 0.259786 -9.19674 -9150 6 33.6805 18.2019 10.4544 40.2358 -26.4835 -11.4715 -9151 4 34.2537 18.8203 9.96489 -9.74865 -7.15313 7.53482 -9152 4 34.2179 17.3378 10.5117 -27.819 38.8859 -1.78852 -9153 6 38.8962 33.7675 36.7566 23.6769 3.34821 -39.6603 -9154 4 38.383 33.5793 35.9171 9.63189 4.7017 21.543 -9155 4 39.855 33.8637 36.4612 -29.1237 -5.01255 9.39617 -9156 6 45.367 13.0954 20.2202 -17.4715 7.54819 27.7127 -9157 4 45.262 12.6289 19.4029 4.78427 -8.6457 -19.3619 -9158 4 44.4728 13.0498 20.6095 8.33403 2.77458 -3.46579 -9159 6 36.394 32.2025 8.83838 -5.39961 -0.779561 10.8196 -9160 4 36.3766 31.4559 9.45045 4.37642 -0.919546 -0.394048 -9161 4 35.9671 32.9207 9.33542 2.20851 -0.984819 -7.57369 -9162 6 7.93081 27.8143 6.16526 -1.31132 8.47671 -18.7581 -9163 4 8.2701 27.2941 6.88743 5.87236 -5.84072 6.56369 -9164 4 8.18271 28.7096 6.41539 -7.71007 1.94397 -1.55613 -9165 6 14.2797 4.87717 33.6823 -38.1616 11.9775 -32.0892 -9166 4 13.6477 5.2447 32.9846 23.9092 -16.4836 27.177 -9167 4 14.8408 5.63056 33.8658 12.4601 7.15131 6.13949 -9168 6 12.2578 8.65243 9.85848 -4.82715 -2.24662 -5.48477 -9169 4 12.6456 8.73928 10.7118 23.7259 9.48722 19.5525 -9170 4 11.4378 8.2214 10.089 -13.622 -8.47682 -13.9839 -9171 6 29.7261 31.9842 8.54243 -17.2145 25.3825 -18.7463 -9172 4 30.1804 31.833 9.34913 11.7892 -12.8324 21.9258 -9173 4 29.6399 31.1708 8.03663 5.85846 -6.51984 4.51241 -9174 6 22.3891 10.8785 21.4662 8.73739 -5.18702 6.55753 -9175 4 21.8037 11.1386 20.7714 -14.2177 0.338512 -24.4291 -9176 4 22.2091 11.5521 22.1168 2.36988 5.22793 14.1218 -9177 6 54.1797 27.5396 12.9955 26.3988 -18.3584 17.6139 -9178 4 0.160041 27.5787 13.0909 -6.71045 -5.06664 4.99497 -9179 4 53.9798 28.2721 12.4475 -15.7222 27.4826 -22.0497 -9180 6 7.71973 13.812 20.0407 -34.9077 17.0186 -30.9147 -9181 4 8.32362 14.1503 20.6766 20.1403 8.526 22.156 -9182 4 7.35968 14.6399 19.6101 8.73645 -26.5601 8.16532 -9183 6 19.7932 0.841243 24.7869 -1.21084 18.2021 12.2367 -9184 4 19.1669 1.06895 25.5104 7.86649 -0.445713 -11.3386 -9185 4 20.4073 1.61074 24.7031 -15.4775 -18.2332 3.4978 -9186 6 3.01312 10.0986 2.94829 -27.2997 12.089 -8.88269 -9187 4 2.52802 10.9508 2.83041 12.1807 -20.5661 3.67701 -9188 4 3.91304 10.3154 3.17839 17.025 6.36995 4.07131 -9189 6 15.8857 13.0124 24.0049 15.5529 -4.67501 -5.43243 -9190 4 15.0856 13.5308 24.0834 -5.13718 6.9751 3.63726 -9191 4 16.3233 13.139 24.8614 0.105722 -2.17465 -3.852 -9192 6 17.0852 4.33969 26.9167 21.5143 -4.09641 1.48348 -9193 4 16.9912 4.27513 25.9666 -0.355278 1.74978 -10.9716 -9194 4 18.0601 4.31538 27.0472 -16.9044 3.21714 1.83131 -9195 6 33.6168 39.4091 10.6433 -2.74936 14.5855 -32.8438 -9196 4 33.9454 38.5625 10.8616 8.60753 -33.4012 17.9817 -9197 4 33.8375 39.4354 9.68976 -8.01757 16.2593 11.171 -9198 6 36.2326 1.10755 13.0941 -10.1125 -3.31802 -5.56412 -9199 4 35.6506 0.392496 13.3579 -10.7819 -8.26966 -9.36682 -9200 4 36.7599 1.20112 13.8707 17.1874 9.72194 12.3054 -9201 6 40.862 19.2925 5.11158 -0.402197 -15.9333 44.5432 -9202 4 40.3871 19.4968 4.34679 -15.032 12.6888 -52.1674 -9203 4 40.1189 19.1611 5.72143 13.4548 0.976419 10.4775 -9204 6 2.35452 37.5497 10.1778 32.5589 0.132829 19.8916 -9205 4 3.04634 37.0953 10.7141 -10.4583 9.64478 -9.40166 -9206 4 1.85979 36.8581 9.75685 -15.4906 -16.9123 -13.0897 -9207 6 8.10293 29.0334 15.8847 29.3895 -23.7333 0.542295 -9208 4 9.03551 28.6824 15.7668 -29.6945 17.5799 0.572456 -9209 4 8.18484 29.8326 16.4072 3.85606 5.10463 3.42896 -9210 6 47.3132 26.514 12.5427 4.56821 28.1849 -37.0073 -9211 4 47.5111 27.2634 11.8891 -8.56493 -28.9528 31.2783 -9212 4 47.3519 25.7475 11.9556 -1.34676 -3.33794 4.54904 -9213 6 33.5886 17.4994 0.666432 -7.15301 -2.01744 8.51284 -9214 4 32.6196 17.5968 0.930917 31.8637 -19.8727 -7.43903 -9215 4 33.9404 16.5735 0.747207 -21.2256 15.6146 2.50609 -9216 6 38.9757 15.6004 36.3686 4.31005 -11.6982 -11.4703 -9217 4 39.1719 14.652 36.4294 -3.02079 4.3409 1.02949 -9218 4 39.3764 15.8813 35.5317 -1.53099 5.14915 -0.246696 -9219 6 34.8198 34.351 9.37266 2.46578 -22.7668 -16.8875 -9220 4 35.3506 35.0289 8.96724 14.9634 11.0695 -15.2613 -9221 4 34.4558 34.8191 10.0913 -19.5236 18.4179 34.8179 -9222 6 44.9681 2.58102 14.7874 21.8703 21.498 2.75759 -9223 4 44.0383 2.44896 14.9383 -16.9502 -5.72583 1.77575 -9224 4 45.1679 3.47323 15.1264 -3.49788 -5.23458 -3.46791 -9225 6 42.6138 38.2902 19.8325 18.6047 12.1973 -29.2276 -9226 4 42.7029 39.1598 19.3445 -0.0117609 -27.8329 13.7468 -9227 4 43.0921 37.6383 19.2425 -13.1736 20.1758 17.0781 -9228 6 18.6869 26.7647 30.2619 -33.6624 -6.012 -17.6355 -9229 4 18.1258 26.7596 29.445 14.3051 -0.674317 21.614 -9230 4 19.5687 26.9499 29.9621 19.5047 4.84041 -5.57389 -9231 6 38.8661 37.7421 16.4836 -9.78438 -6.51051 7.80135 -9232 4 38.7478 36.8102 16.2377 -7.01003 6.44463 1.75037 -9233 4 39.8105 37.8446 16.5724 18.1337 5.4462 2.51551 -9234 6 49.3017 9.82081 12.5377 12.9664 18.8416 30.0962 -9235 4 48.8085 9.39111 11.8826 -17.6666 -23.7062 -38.8329 -9236 4 48.5984 10.2345 13.0427 4.42646 9.01279 7.79627 -9237 6 43.2246 7.36268 19.8264 -1.99344 11.167 24.993 -9238 4 42.5572 7.81175 20.4051 12.7818 -10.9207 -14.0727 -9239 4 44.1025 7.51179 20.2375 -5.96789 -3.6213 -7.06723 -9240 6 36.3461 38.714 4.42821 -2.77728 9.11116 8.98737 -9241 4 36.8002 39.5234 4.70824 5.05063 -6.10698 -1.49424 -9242 4 35.4394 38.9016 4.68929 -3.84434 -7.68842 -3.54296 -9243 6 27.8 17.802 15.105 0.992317 -7.44098 -8.78046 -9244 4 27.5393 16.935 14.729 3.58787 16.6938 2.50389 -9245 4 27.8517 17.6781 16.0585 0.147204 -0.130556 3.13955 -9246 6 18.0837 3.77506 37.3201 -10.3169 -12.5791 -10.2966 -9247 4 18.6663 3.07474 37.0146 -2.03685 -5.25132 -4.70316 -9248 4 18.6637 4.19691 37.9324 10.4473 20.1285 21.3871 -9249 6 7.71395 11.575 6.52222 6.59834 -21.2687 20.1659 -9250 4 7.75955 12.4254 6.93969 -0.705235 13.257 9.50392 -9251 4 7.66936 11.739 5.5978 -3.42683 1.36071 -31.338 -9252 6 31.4909 14.3449 18.0451 -1.46982 -12.276 17.176 -9253 4 32.1287 14.6507 17.397 7.38292 5.65775 -7.44504 -9254 4 32.0331 13.8785 18.7146 -6.90734 4.25576 -5.30331 -9255 6 50.3346 30.4143 8.91505 10.1635 2.25064 -1.90936 -9256 4 49.6557 30.853 8.39615 -4.47176 4.28708 -1.87566 -9257 4 50.0231 29.531 9.11356 -2.73977 -1.84009 2.34474 -9258 6 42.1686 10.1057 12.759 16.2008 2.03437 -4.20809 -9259 4 41.2649 9.83209 12.6487 -17.4225 -8.81494 -4.74081 -9260 4 42.1292 10.8861 13.3105 -1.28453 5.18814 5.66853 -9261 6 37.773 3.09539 32.5582 -5.24906 4.78867 -2.39206 -9262 4 38.0736 3.99724 32.5969 21.7942 11.3719 -4.3192 -9263 4 36.8519 3.25822 32.7463 -19.4678 -11.9252 3.55114 -9264 6 35.7586 13.1005 19.2721 9.99017 -22.7528 0.0781354 -9265 4 36.1308 13.8223 19.7887 2.26592 2.2719 5.61144 -9266 4 36.2509 12.2915 19.5517 -9.66412 15.3645 -2.5809 -9267 6 45.5318 4.12684 21.4944 7.1153 -16.224 0.922187 -9268 4 45.5588 4.23252 20.5315 -1.8039 6.94223 3.67507 -9269 4 45.7548 3.18328 21.6122 -5.15542 13.2346 -0.821742 -9270 6 16.876 1.8608 31.4782 -3.84426 -17.9183 -35.0426 -9271 4 16.0621 2.17388 31.0004 15.6258 0.929179 27.3362 -9272 4 17.1381 2.25043 32.3174 -12.6393 14.1325 4.42374 -9273 6 14.0947 4.88307 23.5769 -10.6061 -28.6131 16.0669 -9274 4 13.8059 5.76888 23.7237 -2.25817 32.588 -6.82267 -9275 4 13.6039 4.42137 24.2892 9.04813 -2.88937 -11.9208 -9276 6 38.3208 33.7635 12.3625 -16.3318 -7.70706 -26.0192 -9277 4 38.1373 32.9408 11.8506 0.297782 14.7405 12.2413 -9278 4 39.1486 33.6221 12.8093 16.0136 -1.39994 11.7584 -9279 6 35.6849 3.05753 37.6719 3.72695 1.1389 -16.7638 -9280 4 35.1101 2.5063 38.212 -4.0587 0.687226 6.19097 -9281 4 35.8854 3.87289 38.1447 -1.86413 5.08658 8.8135 -9282 6 31.3385 37.395 35.3723 -12.2239 -8.91609 34.0312 -9283 4 32.2231 37.7249 35.5382 9.93962 6.70229 -3.55138 -9284 4 31.225 37.4524 34.4409 4.86335 0.993516 -31.3389 -9285 6 52.0614 11.7324 14.0182 20.1458 -4.7001 -39.6215 -9286 4 52.0268 11.0667 13.2735 0.495691 14.4049 24.809 -9287 4 52.7095 12.4171 13.7023 -24.8081 -17.2766 13.6147 -9288 6 26.3478 3.42613 41.0189 1.80794 1.58056 -19.374 -9289 4 25.6151 4.01507 40.9203 -25.7718 5.99951 16.8165 -9290 4 26.7914 3.68675 40.2055 22.5797 -12.3384 -0.204994 -9291 6 24.3802 34.9453 11.1613 28.8325 38.7039 -6.19962 -9292 4 24.3515 34.6784 12.0652 -4.50215 -14.1529 28.2178 -9293 4 23.9023 34.3202 10.6558 -20.492 -31.6724 -14.1682 -9294 6 32.0094 7.59293 31.2147 -3.26399 8.81733 5.62682 -9295 4 32.0976 7.47613 30.2777 2.1706 -0.778595 -17.1478 -9296 4 31.5266 8.43606 31.2858 0.565291 -7.84955 4.65821 -9297 6 28.7282 2.60805 0.424377 -15.1279 1.50585 -5.39222 -9298 4 29.2952 2.36387 41.5859 -5.33248 3.35197 5.42737 -9299 4 27.7901 2.65331 0.119401 23.4632 0.0509354 2.06419 -9300 6 42.125 19.2126 9.86039 10.7783 -7.26578 33.4177 -9301 4 42.6695 19.2101 10.7019 -20.1092 0.869002 -30.5597 -9302 4 41.4363 18.5278 9.96356 3.48727 6.10561 -4.25932 -9303 6 33.0194 27.0842 8.32851 16.6372 -6.55357 -10.7525 -9304 4 33.8911 27.0001 7.90493 -7.38323 -0.765342 -2.5624 -9305 4 33.2437 27.3744 9.20899 -0.425855 7.33259 11.2137 -9306 6 4.16433 8.30018 19.1575 16.0783 -2.51395 5.95143 -9307 4 4.71165 7.98099 18.3991 -19.3854 5.29846 8.38252 -9308 4 3.22273 8.32359 18.9288 3.05712 -5.28108 -12.2975 -9309 6 20.7745 29.1912 37.0609 -25.9123 -20.3491 -5.83769 -9310 4 21.0713 28.277 37.0594 -15.1664 -12.7508 0.5123 -9311 4 21.6013 29.5933 37.1743 32.957 35.4267 8.73191 -9312 6 13.1089 4.99809 10.9103 2.80775 13.1965 -7.17841 -9313 4 13.4591 5.85092 11.2415 -2.5949 -14.1267 -1.88178 -9314 4 12.7051 5.16456 10.0462 -1.2434 3.82389 2.90473 -9315 6 37.5087 18.1031 32.5343 20.0502 31.699 14.1692 -9316 4 38.1018 18.8164 32.1735 -18.2411 -21.7333 4.56216 -9317 4 37.2041 18.4813 33.3903 1.90105 -7.17599 -12.7275 -9318 6 17.7655 33.2839 30.7231 12.9967 19.9173 -17.9311 -9319 4 17.8488 34.0437 30.1253 -3.68331 -4.50715 1.49576 -9320 4 18.5638 33.345 31.2563 4.57995 -0.934488 4.72964 -9321 6 23.1969 32.7832 9.90135 2.14033 10.4984 -5.43395 -9322 4 23.4737 31.9362 10.2634 3.28964 -4.66398 1.33779 -9323 4 22.2469 32.7196 9.72631 0.753558 0.42269 -0.434072 -9324 6 14.8911 9.35828 34.246 -8.54616 0.784134 0.501674 -9325 4 15.4672 8.59016 34.1372 5.2294 -0.0873347 -3.8795 -9326 4 15.23 10.0905 33.7027 2.53244 -1.05206 0.202563 -9327 6 31.1203 39.3599 38.5719 4.30147 -17.578 8.21172 -9328 4 31.5941 38.6377 39.0527 -10.1026 17.4492 -9.05875 -9329 4 30.4019 38.9077 38.1077 1.84332 2.82409 1.03593 -9330 6 5.29005 34.4279 28.2716 -0.764315 -10.945 -9.90403 -9331 4 5.24266 35.3772 28.447 -0.427568 -2.02335 -2.15628 -9332 4 5.18384 34.3192 27.3143 2.05225 4.04935 9.99949 -9333 6 30.3216 21.6974 14.1256 3.24994 1.03129 -0.468005 -9334 4 30.4656 20.7696 14.235 0.884625 -14.9253 16.053 -9335 4 30.3519 21.7638 13.1772 -0.963709 16.3006 -15.7103 -9336 6 23.8542 39.0018 28.2919 38.6077 23.8437 -8.99828 -9337 4 23.8505 39.6937 27.6143 9.44649 3.56781 3.51793 -9338 4 23.0185 38.6309 28.1896 -50.029 -28.3524 0.952356 -9339 6 9.61332 13.5451 16.4567 13.7131 10.5156 -25.323 -9340 4 8.77595 13.0917 16.3907 -9.93448 -5.52821 8.41851 -9341 4 9.74204 13.8378 15.5322 5.69689 -3.544 12.5309 -9342 6 25.9753 6.18174 15.7989 23.4837 -9.67411 23.9067 -9343 4 26.0218 6.10484 14.8454 5.11216 -1.95092 -7.71856 -9344 4 26.7445 5.66727 16.1761 -27.6477 18.1551 -17.3833 -9345 6 15.9921 33.6419 22.5616 2.25497 8.86036 -26.9911 -9346 4 16.0049 34.0594 21.6804 -4.22455 0.568633 15.0409 -9347 4 16.1032 32.7157 22.281 -1.05219 8.42244 16.6761 -9348 6 40.6812 13.5416 12.1266 -4.5396 -12.3661 6.74099 -9349 4 40.4134 12.947 11.4149 -4.75912 -2.4644 -8.17888 -9350 4 41.058 12.9332 12.7776 -0.386087 8.79442 1.8157 -9351 6 35.5875 40.2809 31.6993 12.2791 -13.6127 -29.8257 -9352 4 35.948 40.913 31.0681 -4.17713 12.2213 7.17402 -9353 4 35.6271 39.4709 31.1475 -9.59473 3.36029 20.1077 -9354 6 19.3493 17.5927 17.849 24.123 48.8902 3.26857 -9355 4 19.9577 18.423 17.9915 -34.5112 -38.8316 -9.06029 -9356 4 18.6928 17.806 17.1645 6.15508 1.01267 5.31501 -9357 6 7.96541 28.082 10.7737 20.0283 17.3944 8.50509 -9358 4 8.43659 28.8341 11.2297 -13.1431 -15.7733 -11.3814 -9359 4 7.20109 28.4458 10.3015 -0.215648 4.06143 0.688545 -9360 6 32.1489 39.5869 16.6475 -7.37335 1.81146 -4.92627 -9361 4 31.705 40.4043 16.3332 3.90743 -15.5774 4.53996 -9362 4 31.4977 38.8659 16.5723 3.01217 10.596 3.08762 -9363 6 35.8095 2.63602 18.127 2.07542 -14.8225 4.13142 -9364 4 34.8947 2.32962 18.1713 7.15775 -3.6283 3.09768 -9365 4 35.7135 3.4873 17.7367 2.81673 20.5762 -11.5045 -9366 6 14.9588 39.9585 36.8943 -2.86001 -28.3727 24.0409 -9367 4 15.4545 39.4909 36.2335 10.0689 -8.68258 -13.459 -9368 4 15.0094 40.8569 36.655 2.72867 44.443 -9.08423 -9369 6 18.3115 32.3916 11.4639 8.59274 12.4423 14.7113 -9370 4 18.6438 32.5881 12.3772 -9.2478 -5.5834 -23.9484 -9371 4 17.8762 33.212 11.1576 6.35145 -13.5457 0.164794 -9372 6 14.605 10.3819 4.99774 5.57597 -6.68493 12.6773 -9373 4 13.677 10.4388 4.75284 -6.10435 1.24571 -3.75468 -9374 4 14.6185 10.047 5.91478 4.2493 4.0336 -10.9734 -9375 6 2.02851 14.3408 39.1627 -4.03313 12.5981 -1.48522 -9376 4 2.74992 15.009 39.2086 -14.5088 -8.45155 5.07373 -9377 4 1.21458 14.679 39.6124 19.1623 -3.42757 -8.41789 -9378 6 7.58709 14.1522 32.4651 10.4977 19.6861 -0.504887 -9379 4 6.93593 13.6605 32.9674 -3.57672 2.30039 3.8359 -9380 4 7.5987 15.0834 32.797 -1.90079 -22.9019 -5.87851 -9381 6 6.15309 23.123 37.664 -26.7168 -14.8188 -11.2926 -9382 4 6.52639 23.9838 37.7378 17.5333 20.6862 9.20416 -9383 4 5.45539 23.2608 36.9958 8.40974 -10.7335 8.81374 -9384 6 37.3009 22.5422 4.44282 21.6187 66.9857 0.670839 -9385 4 36.5208 22.1217 4.15693 -30.5217 -23.5005 -12.8181 -9386 4 37.1232 23.5227 4.23696 10.5274 -41.8214 11.62 -9387 6 47.1349 31.0113 5.88613 -14.3653 5.64202 -58.02 -9388 4 46.9542 30.9019 6.7933 -9.29323 -2.10558 39.1512 -9389 4 46.2627 31.2059 5.44524 20.5013 -7.22248 10.5418 -9390 6 54.8094 25.5909 34.9286 -5.37395 41.5808 12.672 -9391 4 54.0266 25.5089 35.4943 -0.981006 -11.4098 -6.26775 -9392 4 0.0616925 26.543 35.1263 -1.5494 -32.4448 -11.2369 -9393 6 37.1551 2.08197 4.79239 -12.5712 23.0197 -22.5278 -9394 4 36.5844 2.86136 4.61445 9.59981 -14.8952 -2.62483 -9395 4 37.0798 1.96202 5.72873 2.5296 -7.23911 19.6989 -9396 6 22.5239 28.6012 8.91155 -7.98869 19.6075 21.4366 -9397 4 22.8946 28.4124 9.79991 -0.853296 -5.89568 -17.4096 -9398 4 22.801 27.9767 8.25343 10.1708 -14.6558 -3.7409 -9399 6 8.64208 27.1509 24.5664 -38.2161 25.5543 4.78276 -9400 4 7.71753 26.8887 24.5582 -5.16372 11.0804 -0.386298 -9401 4 9.04357 26.3309 24.4724 40.7169 -47.477 -5.23592 -9402 6 1.14997 23.727 2.4309 6.46058 8.65979 -14.8341 -9403 4 1.18232 23.9936 1.48373 -6.63581 -4.99587 16.5657 -9404 4 0.310199 23.2733 2.54924 -0.981545 -0.950126 -1.89037 -9405 6 54.3702 30.2259 27.0243 -0.035121 6.58363 -4.50453 -9406 4 54.2615 29.4654 26.4339 1.23903 8.74071 -4.24792 -9407 4 54.6064 30.9974 26.4582 -3.83852 -12.4126 5.30421 -9408 6 0.386829 8.42023 23.9938 5.00922 -16.8445 -6.80376 -9409 4 1.36083 8.4508 24.0758 -8.17173 1.21512 3.08891 -9410 4 54.9524 8.88826 24.7258 9.13745 3.54566 6.13736 -9411 6 16.8971 28.5839 33.3722 23.8511 -30.9569 -4.46587 -9412 4 17.442 28.7831 34.1436 -6.82268 9.96305 3.46007 -9413 4 17.4403 27.8723 32.949 -23.4552 19.8179 6.40974 -9414 6 33.6969 30.8931 0.141175 14.1795 0.777253 -0.635822 -9415 4 34.6278 30.5945 0.162696 -6.8513 6.78484 1.91826 -9416 4 33.3211 30.3583 41.3463 -2.66034 -4.05802 -0.0970656 -9417 6 16.2525 21.5202 34.1552 3.2099 -15.0674 -0.387853 -9418 4 16.0099 20.7546 33.5903 4.90739 13.2878 5.87792 -9419 4 16.6977 21.1376 34.9376 -8.96682 7.2262 -10.6242 -9420 6 0.22977 17.7868 35.7492 -9.57638 -14.7124 1.37696 -9421 4 54.2434 17.9569 35.6827 28.6901 -4.22084 5.11773 -9422 4 0.351694 16.93 36.209 -4.1051 13.1178 -5.65765 -9423 6 16.8289 12.2962 0.019427 11.8958 12.8939 11.6481 -9424 4 17.3016 12.8498 0.703368 -12.3262 -21.137 -14.7379 -9425 4 16.4403 11.4936 0.411486 1.39397 8.07719 2.11333 -9426 6 8.24246 9.54397 36.2629 -25.8472 21.2414 2.40819 -9427 4 7.81464 8.9356 36.8788 1.26461 -2.06425 2.56422 -9428 4 7.48979 10.0869 35.9067 16.4576 -8.29365 1.86334 -9429 6 48.5761 26.718 39.8382 -16.8767 -13.2223 25.9758 -9430 4 48.2189 26.9037 38.9774 0.202946 6.43929 -15.4249 -9431 4 49.4865 26.9849 39.8847 17.129 6.93076 -9.10183 -9432 6 35.4777 1.07865 23.1156 20.3084 9.46551 28.8556 -9433 4 36.0215 1.72656 22.6213 -7.75205 -10.5654 8.45632 -9434 4 35.804 1.12911 24.09 -10.3378 -1.68949 -45.1242 -9435 6 20.2777 30.6326 19.3782 17.168 -16.4055 9.77372 -9436 4 20.2499 31.0311 20.2788 1.56461 -6.55175 -10.0354 -9437 4 20.938 29.881 19.3855 -20.6701 22.3694 2.2449 -9438 6 44.3702 15.9458 1.58361 10.9348 22.193 31.2112 -9439 4 44.4077 15.6379 2.51116 -1.71559 -1.42871 -18.164 -9440 4 44.6431 16.8967 1.66823 -9.97295 -22.8516 -13.6111 -9441 6 53.8845 34.4651 10.6068 -24.0145 7.95167 -19.3224 -9442 4 54.4361 34.2696 11.3314 22.7066 -9.19703 33.7305 -9443 4 54.2985 35.2035 10.1555 0.2437 -1.83103 1.50375 -9444 6 46.1364 32.8471 33.519 4.96533 -12.2334 2.48444 -9445 4 45.9404 33.6629 33.0556 -3.66306 8.73713 -2.86335 -9446 4 47.0477 32.6179 33.2654 -4.26196 1.19291 1.09329 -9447 6 42.1324 21.9098 24.2239 34.4777 -24.9191 34.4505 -9448 4 43.0412 21.5159 24.3646 -28.4667 14.3091 -11.1056 -9449 4 41.7437 21.6811 25.0949 -3.80951 9.2794 -19.6729 -9450 6 8.14185 3.89847 11.6387 2.30661 -15.3192 6.95264 -9451 4 7.35197 4.1174 12.1322 -8.99547 12.8437 -2.29886 -9452 4 8.35392 3.05748 12.0535 10.9023 -1.5691 -3.31016 -9453 6 19.6413 41.6808 9.8267 1.07442 6.29255 0.337359 -9454 4 18.9204 41.094 9.57509 0.414049 2.67892 1.92063 -9455 4 19.352 0.205183 10.6506 0.427822 -12.2572 -10.0953 -9456 6 42.3157 8.41085 31.6785 13.3628 11.5473 -7.23952 -9457 4 41.3969 8.42848 31.9417 -9.73605 -1.80426 0.915182 -9458 4 42.5534 9.35818 31.5624 -0.333442 -16.319 1.99913 -9459 6 26.911 16.154 25.3637 -0.10907 13.2502 -20.6653 -9460 4 26.7939 15.8861 24.4207 -0.565005 2.37017 21.4763 -9461 4 26.6835 15.4121 25.9182 -3.52016 -12.4926 6.14171 -9462 6 48.2345 6.48613 12.6212 -1.55264 -8.09911 -9.8466 -9463 4 48.9652 6.31914 12.0011 -5.93235 3.28214 2.19301 -9464 4 47.4516 6.10442 12.1764 7.36669 2.93589 5.65527 -9465 6 53.4556 41.5274 30.6561 0.928349 -3.66285 -10.4005 -9466 4 53.9738 41.8466 29.9077 -1.68735 -3.84443 -4.80087 -9467 4 53.7246 0.16796 31.3785 5.2081 5.34012 15.7103 -9468 6 47.0719 22.4215 31.8177 3.79963 28.0651 -15.4962 -9469 4 47.8542 22.5824 31.2379 -15.4047 -7.22606 14.7582 -9470 4 46.5391 23.2393 31.6689 5.43499 -22.2824 10.2038 -9471 6 19.5241 5.44646 15.2431 57.7261 9.00726 -25.1025 -9472 4 19.973 4.5781 15.2547 -6.4602 7.66804 1.10752 -9473 4 18.6769 5.33307 15.596 -47.9766 -8.78418 19.1468 -9474 6 14.6808 30.2445 33.392 16.954 11.9814 -17.0239 -9475 4 15.1668 30.8865 32.8123 -10.4914 -16.0898 10.6301 -9476 4 15.2553 29.4559 33.3904 -4.22445 9.80292 -0.52553 -9477 6 28.4427 24.2289 10.4187 -0.774793 -27.6212 -36.8967 -9478 4 29.277 24.4414 10.8128 10.21 14.4589 20.8069 -9479 4 27.7162 24.5027 10.9517 -9.91177 12.6254 22.5109 -9480 6 5.25429 14.4357 24.4952 18.8694 8.38265 -3.5804 -9481 4 4.38598 14.1455 24.6681 -43.369 -9.18674 12.4123 -9482 4 5.45154 13.9758 23.6794 9.52503 -2.95522 -10.1363 -9483 6 26.3476 19.2988 19.1857 11.4015 -18.2951 -12.5804 -9484 4 26.5417 20.1869 19.4853 3.52858 10.6793 1.31948 -9485 4 27.146 18.9308 18.7141 -21.2465 13.7562 17.259 -9486 6 28.5834 7.44603 13.1845 8.68409 29.8386 11.3246 -9487 4 28.3961 6.55455 12.9442 -2.45324 -19.0833 -9.20205 -9488 4 29.0571 7.89665 12.4686 -5.14786 -6.54739 -1.73865 -9489 6 5.35742 27.1473 37.0464 13.0843 -4.728 13.8292 -9490 4 6.09472 26.8663 37.6487 -17.7636 2.66278 -18.049 -9491 4 5.49884 28.0724 36.7882 1.93418 -3.90879 0.386893 -9492 6 53.1466 13.4128 16.1104 33.6732 -23.607 0.886679 -9493 4 54.0532 13.0537 15.8959 -24.4904 18.1541 2.55443 -9494 4 52.6056 12.6236 16.2807 -0.490038 10.6025 -2.0621 -9495 6 45.4595 1.03561 24.6152 0.883869 7.22473 8.82703 -9496 4 44.8005 0.912307 23.9218 -0.0838502 -1.3445 -1.23214 -9497 4 44.9845 0.757767 25.4168 6.19386 0.932014 -5.94613 -9498 6 50.1542 2.38642 13.9319 -2.4774 12.931 -1.3926 -9499 4 50.7815 2.76975 13.3044 0.014285 -4.08681 1.38242 -9500 4 49.5062 3.09016 14.0651 -1.63783 -0.639647 1.83323 -9501 6 19.5885 31.0175 39.1657 -10.9837 -21.6636 -18.6241 -9502 4 19.8079 30.3148 38.4832 -5.60324 21.7545 20.6111 -9503 4 18.6148 30.9453 39.3442 26.0441 2.6939 -5.02925 -9504 6 19.2491 14.7106 10.8907 20.9533 -11.5465 -13.087 -9505 4 20.0062 14.1954 10.4207 -44.2836 18.7066 28.5885 -9506 4 18.7045 14.0688 11.3882 14.1221 2.37282 -8.47947 -9507 6 4.44986 39.5549 20.1348 -7.46971 20.8744 22.4052 -9508 4 3.99116 40.4291 20.2667 12.3042 -22.0468 -4.08326 -9509 4 4.78876 39.261 21.0122 -11.398 5.88582 -21.7205 -9510 6 29.0264 13.3645 23.891 3.80322 20.0192 21.3715 -9511 4 28.7263 12.4558 23.8574 1.87437 -3.97007 -2.19356 -9512 4 28.9189 13.5991 24.8488 7.01015 0.856522 -27.3099 -9513 6 17.0674 2.76528 17.6511 13.6679 -9.88609 -24.0062 -9514 4 16.9089 3.43106 16.9566 -0.337692 -4.66999 2.92783 -9515 4 17.7694 2.16287 17.2836 -16.7881 13.7863 9.44417 -9516 6 43.472 18.0456 17.7207 2.90116 -6.00314 -10.3001 -9517 4 43.5328 17.0661 17.6262 0.602958 19.7978 9.46789 -9518 4 43.5843 18.2505 18.6627 0.176297 -8.32564 -1.3476 -9519 6 25.7838 40.7303 1.24723 -3.64329 26.5644 -28.0564 -9520 4 26.2198 41.3001 1.88369 1.46132 -2.86659 8.1156 -9521 4 25.5777 41.3986 0.532216 -2.57635 -28.6607 13.7824 -9522 6 0.458758 22.8928 6.22327 -2.28892 -3.37321 -2.62932 -9523 4 0.911995 22.0955 5.88137 -3.49653 6.37629 4.11618 -9524 4 1.15027 23.4262 6.63616 1.38998 -0.611711 -3.15133 -9525 6 26.2502 35.0072 18.629 11.2346 5.37396 -16.6635 -9526 4 25.9102 35.926 18.5821 -1.77201 -16.2127 4.61622 -9527 4 25.7094 34.5197 19.2578 -0.594129 4.22999 1.61862 -9528 6 16.1509 31.8837 7.54876 40.1408 -29.5169 -1.86921 -9529 4 16.9528 31.2446 7.38162 -38.5191 36.6879 6.5811 -9530 4 16.2422 32.6162 6.9246 8.25996 -4.45471 -3.71716 -9531 6 22.9569 16.8424 28.5503 -18.0144 15.9011 -12.9281 -9532 4 23.0242 16.0615 27.9964 2.65193 -8.47258 -0.731728 -9533 4 22.0914 17.2685 28.2981 23.9965 -14.5366 15.8079 -9534 6 48.817 29.3453 32.1483 10.2159 -3.67765 25.2301 -9535 4 47.913 29.23 31.8533 -10.4354 1.38436 -5.08298 -9536 4 48.8482 28.9579 33.0615 0.343667 8.53482 -20.1614 -9537 6 13.1275 24.857 5.54597 -15.7655 12.0094 -10.6158 -9538 4 12.8967 24.1126 4.95892 -3.19147 7.26676 2.83523 -9539 4 12.4206 25.5605 5.45199 17.9822 -22.1189 1.55356 -9540 6 10.967 20.7149 15.8389 3.49035 -8.57129 -4.90872 -9541 4 10.8232 20.5385 14.8814 6.84933 2.21154 19.4522 -9542 4 11.8211 20.2878 16.0966 -18.2767 7.30584 -13.8769 -9543 6 13.8574 18.376 6.9425 -18.5688 18.5302 -26.9748 -9544 4 14.0551 19.3329 6.99178 3.58444 -10.9562 5.12073 -9545 4 14.2751 17.8929 7.64202 12.8225 -6.30863 19.0643 -9546 6 13.8485 12.9413 30.6405 -7.33075 -24.1801 -9.47477 -9547 4 13.9233 12.3923 29.8469 14.5901 9.31788 -1.12157 -9548 4 13.0284 12.552 30.9634 -3.13873 11.8242 15.1361 -9549 6 17.1199 6.33729 31.2705 58.4108 60.4292 21.9502 -9550 4 16.7347 7.19592 31.0485 -2.55536 -2.82538 -1.05014 -9551 4 16.4932 5.72664 31.0455 -61.4006 -55.6776 -22.0804 -9552 6 7.63858 23.4232 20.5528 2.70849 -2.51933 -11.6338 -9553 4 7.34936 23.0623 19.6936 2.42656 1.66026 8.60009 -9554 4 8.06294 24.2698 20.3247 -2.54411 -7.58863 2.30144 -9555 6 15.6012 36.6828 25.6308 12.0382 0.865576 2.42327 -9556 4 16.546 36.4866 25.8589 -19.7129 13.5166 -7.57965 -9557 4 15.5566 37.5233 25.1245 15.7859 -9.47529 6.9914 -9558 6 0.738662 10.4099 22.1708 -26.6289 -22.4058 -14.7131 -9559 4 0.0268398 10.3645 21.4686 20.8647 0.21224 20.3485 -9560 4 0.555589 9.63254 22.7491 3.84168 18.0907 -12.5939 -9561 6 33.5034 17.3959 33.5951 21.201 30.6084 -13.4811 -9562 4 33.5895 18.3893 33.3705 0.776259 -45.1899 5.95193 -9563 4 34.1847 16.8766 33.1005 -9.04546 14.4589 8.38708 -9564 6 21.6622 19.013 20.7578 31.9274 -22.1518 -4.15649 -9565 4 22.4096 19.6032 20.9777 -11.5486 -3.71871 -1.82252 -9566 4 22.1307 18.1402 20.6082 -20.9219 25.304 3.1187 -9567 6 41.7583 19.992 16.8792 -6.68772 4.02339 -8.69865 -9568 4 42.2438 19.1637 16.9575 3.64207 -5.49479 0.617993 -9569 4 41.579 20.1273 15.9247 3.71595 -2.33609 11.0843 -9570 6 12.0355 14.9654 17.6922 -21.5841 1.26502 -18.8824 -9571 4 11.2182 14.5976 17.276 14.8021 5.3277 12.4216 -9572 4 12.4319 14.255 18.1907 -0.352973 -10.2116 7.98966 -9573 6 23.0172 11.4191 40.7206 -10.7217 24.0381 44.0704 -9574 4 22.9528 12.3236 41.1181 -0.480688 -24.3492 -4.33206 -9575 4 23.3445 11.5906 39.8675 15.3819 0.516123 -37.823 -9576 6 21.0055 28.3299 24.5595 -23.1154 26.0001 -7.02903 -9577 4 20.2855 28.1767 25.1713 -12.8069 16.7504 -3.2857 -9578 4 21.5564 27.6405 24.838 35.6802 -30.9994 4.41974 -9579 6 19.406 13.705 31.9364 14.5236 -8.57279 10.3452 -9580 4 18.7521 13.9469 31.2876 -5.81883 0.611034 -8.78432 -9581 4 18.9142 13.6788 32.7621 -0.186305 1.04404 6.29106 -9582 6 21.5918 2.86134 24.7058 -12.3779 12.1824 -8.79066 -9583 4 21.7274 3.16074 23.7816 9.4572 -7.89437 13.7797 -9584 4 22.4025 2.45534 25.0386 5.22934 2.42127 -4.70961 -9585 6 11.3487 29.9838 18.827 10.5554 -3.16976 4.47537 -9586 4 10.5352 30.5203 18.751 15.2364 -2.61973 2.60085 -9587 4 12.0043 30.4181 19.4217 -22.0541 -6.82347 -15.9561 -9588 6 14.6417 22.3529 8.3686 35.183 35.1516 7.4005 -9589 4 14.0314 23.0645 8.61446 -9.87113 -8.59651 0.991548 -9590 4 15.5117 22.8693 8.31218 -34.203 -30.7208 1.23805 -9591 6 43.9533 23.6664 17.2647 -9.15762 31.6597 -10.4885 -9592 4 44.7744 23.2846 16.9678 11.7125 -13.1472 -3.62648 -9593 4 43.5104 22.9908 17.7726 1.91474 -8.51607 6.21827 -9594 6 28.003 25.5014 27.4986 6.23457 -29.1533 -5.23677 -9595 4 27.4849 26.2827 27.5489 -17.6876 27.9136 1.36856 -9596 4 28.906 25.8001 27.3829 8.21911 6.89622 0.0845564 -9597 6 19.1046 26.8047 33.1413 12.2661 11.24 -48.0243 -9598 4 19.0365 26.4782 32.1917 1.11076 11.999 35.7369 -9599 4 19.4769 27.7251 33.0545 -9.7287 -23.6705 8.34301 -9600 6 6.37289 19.3428 5.67363 -3.21133 -16.2285 8.07537 -9601 4 6.7336 20.019 5.09886 3.22925 8.22387 -6.14542 -9602 4 5.58923 19.7346 6.08082 -0.796808 3.74051 2.3056 -9603 6 37.4835 28.3972 9.67963 -16.8252 8.64443 -22.9196 -9604 4 37.8384 28.0931 10.5154 1.79485 -10.7977 1.13655 -9605 4 37.3056 27.6421 9.07717 9.05958 5.47813 21.4583 -9606 6 17.6994 27.086 11.7957 -23.9049 -9.71644 -0.114793 -9607 4 16.9894 26.5877 11.2784 19.3807 18.9653 23.0761 -9608 4 17.3772 27.2467 12.7205 1.32974 -4.86863 -22.184 -9609 6 12.8804 1.95044 24.1635 -16.9081 23.6463 -41.3936 -9610 4 12.0123 2.42693 23.9788 24.6345 -20.1638 18.4271 -9611 4 12.9602 1.63912 25.0531 -11.2641 -4.9093 21.6908 -9612 6 27.8486 37.1249 33.3037 14.5525 0.843809 -12.8082 -9613 4 27.8306 37.7566 32.5563 -0.261378 -9.54721 11.1245 -9614 4 28.4641 36.389 33.0416 -14.495 18.5162 4.94281 -9615 6 18.6769 12.3657 6.31954 -0.243732 -29.9473 12.6257 -9616 4 18.5317 11.3932 6.23771 0.963018 17.4883 6.62231 -9617 4 18.5535 12.6707 5.42951 -3.51714 10.9469 -19.8301 -9618 6 10.1845 29.3127 24.783 -1.36331 5.89889 -4.08473 -9619 4 10.7465 29.1085 25.5662 -10.353 -5.60455 -9.55427 -9620 4 9.5047 28.6152 24.6271 17.6265 9.93184 12.3415 -9621 6 7.25219 3.30976 16.2618 16.5712 6.01323 38.0962 -9622 4 7.85224 3.92676 16.743 -7.28275 2.21025 -21.7569 -9623 4 7.07626 2.67339 16.9792 -0.839688 -3.96601 -21.0406 -9624 6 32.2032 37.556 1.10106 -1.45173 2.30566 -1.67736 -9625 4 31.7319 37.0242 1.72254 -12.3544 -30.6614 1.12887 -9626 4 32.1826 38.3533 1.61216 9.84976 31.1212 -1.90535 -9627 6 10.4132 10.1536 6.41547 2.6172 -5.66149 -5.23088 -9628 4 9.51094 10.4988 6.43252 -1.43241 7.72691 5.99088 -9629 4 10.888 10.4598 7.20926 -10.4429 3.02901 -4.20627 -9630 6 16.1922 23.2473 37.3836 13.4596 17.9231 -6.20094 -9631 4 16.4628 23.5362 38.2769 -1.8179 -2.41291 -6.91424 -9632 4 16.622 23.8878 36.7607 -9.68345 -13.0364 13.8052 -9633 6 24.0933 14.3373 36.5438 -0.810617 7.47513 6.008 -9634 4 25.0172 14.0983 36.6068 9.64822 -3.29568 0.232999 -9635 4 23.7283 14.0715 37.4031 -3.57511 2.15125 -3.19243 -9636 6 27.4694 18.5535 28.7878 -22.2405 -8.90967 9.68842 -9637 4 27.2463 18.155 29.6474 7.14424 4.94771 -10.1046 -9638 4 26.6163 18.5328 28.3045 10.7583 2.44378 -0.411902 -9639 6 51.5617 10.4928 1.56364 -46.044 -5.31617 -17.9438 -9640 4 50.711 10.1131 1.91707 23.1705 13.8427 -10.0979 -9641 4 52.2015 10.4284 2.24991 18.8641 -3.04547 25.194 -9642 6 31.1163 39.6073 27.5052 16.7753 -4.77526 -29.689 -9643 4 30.6203 39.2762 28.2489 -5.6675 10.9492 15.0474 -9644 4 31.3773 40.5466 27.6182 -8.67746 -20.5696 10.3555 -9645 6 6.90447 35.9666 14.3264 -30.1691 -4.34312 14.222 -9646 4 7.61578 36.3042 13.808 21.2575 5.14969 -9.00238 -9647 4 7.11482 35.0613 14.5906 3.01946 -0.973686 -2.74545 -9648 6 45.5514 7.57029 29.1841 -25.615 -5.69379 -2.02895 -9649 4 44.9198 7.51228 28.4263 15.6429 0.393509 16.1679 -9650 4 45.0848 7.11279 29.9186 7.09759 5.05324 -8.24334 -9651 6 31.3626 20.5603 31.6216 46.5235 7.85379 -13.5612 -9652 4 31.9622 21.3332 31.7077 -20.5518 -6.12612 6.97271 -9653 4 31.9328 19.9839 31.0823 -17.3109 -3.90007 7.28444 -9654 6 43.0286 31.1606 10.377 -16.6603 7.93207 28.9623 -9655 4 42.0878 30.8529 10.4887 24.119 8.07098 -2.29185 -9656 4 43.3099 31.4942 11.272 -6.72297 -13.7816 -28.1326 -9657 6 50.925 25.5606 12.6461 -27.6852 -6.08767 20.8539 -9658 4 50.917 26.3683 12.1731 -8.31821 35.0391 -16.2433 -9659 4 51.8024 25.2628 12.5325 34.7451 -18.8429 0.848912 -9660 6 29.3305 2.97987 3.64738 17.2649 -36.5424 -5.61333 -9661 4 29.6156 3.84373 3.86529 8.03017 35.8359 9.57326 -9662 4 28.4158 3.03535 3.41816 -23.9953 6.75187 -10.8335 -9663 6 53.9216 32.1051 20.3724 -11.2223 -0.478332 -4.16652 -9664 4 54.8523 32.157 20.1701 8.27859 1.2318 1.83366 -9665 4 53.5473 31.7256 19.5583 -4.88871 3.83013 8.11791 -9666 6 41.7036 29.5569 6.48267 17.2638 16.7804 -5.64052 -9667 4 40.7698 29.5903 6.27928 -11.16 5.83742 -3.44443 -9668 4 42.1548 30.305 5.99503 -16.5783 -19.3567 12.2041 -9669 6 37.8345 24.5719 39.3019 -13.0469 -9.65298 -3.86921 -9670 4 37.225 24.2046 38.6488 4.5791 4.74434 1.49749 -9671 4 37.4276 24.3068 40.1372 5.55374 4.45167 1.85829 -9672 6 46.5621 27.5658 23.2944 -23.9279 -33.0439 -11.1022 -9673 4 46.4387 27.4786 24.2739 -2.64996 -4.90603 -22.3791 -9674 4 45.938 26.8598 22.8442 32.7587 35.3455 32.269 -9675 6 9.23408 27.197 8.34767 -28.7607 6.82988 18.9345 -9676 4 8.89078 27.6282 9.16421 9.10203 -8.06063 -16.3167 -9677 4 10.1694 27.1106 8.44975 24.8451 0.83524 4.07321 -9678 6 36.0586 34.168 13.9947 0.546429 -20.5208 -0.995849 -9679 4 35.8317 33.2019 13.9926 1.47243 21.3574 0.844463 -9680 4 36.7518 34.2454 13.3214 -1.12661 -0.38848 2.20278 -9681 6 51.6812 14.492 12.3108 14.2062 7.57429 -10.7818 -9682 4 52.2015 14.4126 11.4771 -7.23407 7.45688 18.698 -9683 4 51.902 15.34 12.7416 -3.60656 -14.3916 -9.37264 -9684 6 15.248 19.6366 32.4109 27.4357 -16.6396 -20.9158 -9685 4 15.2931 19.2358 31.5053 -3.54534 7.22564 18.4797 -9686 4 14.3328 19.7639 32.5881 -28.0981 2.1384 2.91772 -9687 6 27.6849 24.6479 38.3573 2.41004 -14.3506 -18.7558 -9688 4 27.9256 25.2107 39.0738 -0.349992 17.1553 25.2623 -9689 4 28.4455 24.6938 37.7731 2.45273 -2.47407 -6.18841 -9690 6 37.5344 9.26205 13.6222 2.62805 -1.42602 2.92011 -9691 4 37.9029 8.73293 14.3466 0.897712 0.834078 0.0180659 -9692 4 37.323 10.115 14.0326 -0.799981 -1.44542 -1.10758 -9693 6 20.9013 33.2307 26.2512 6.46074 3.54373 3.40895 -9694 4 21.2661 33.4546 27.1222 -3.70394 5.03607 -5.2507 -9695 4 21.0534 32.294 26.1755 2.06129 -12.757 -1.69162 -9696 6 6.58179 13.9421 35.2385 -0.161437 -23.8226 2.06013 -9697 4 6.46846 12.9778 35.1898 -10.847 5.63462 -0.921172 -9698 4 7.53649 14.0007 35.2781 8.40152 11.229 1.63712 -9699 6 10.0736 7.47184 6.87074 6.29005 1.76204 -5.26249 -9700 4 9.16789 7.18556 6.66525 -0.124912 3.45645 -0.864518 -9701 4 10.1825 8.41968 6.63706 -5.90018 -13.0861 3.35766 -9702 6 31.1989 5.96627 11.4256 47.5137 28.7614 23.6553 -9703 4 31.4466 6.13876 12.388 -20.2952 -9.94335 -33.1747 -9704 4 32.0308 6.26994 10.9806 -22.1211 -12.2896 5.82222 -9705 6 12.1387 3.84993 35.2935 2.49551 -0.304387 23.4243 -9706 4 12.8187 4.19174 34.7257 10.4227 4.50872 -14.559 -9707 4 12.5185 4.00559 36.1769 -9.60543 -1.42105 -7.76228 -9708 6 5.33665 6.07757 27.6447 8.69228 -34.5823 40.5077 -9709 4 5.10952 6.83187 28.1919 -5.14709 12.9851 -0.252954 -9710 4 5.24124 6.31071 26.7545 -7.00092 22.4827 -45.3835 -9711 6 13.1372 33.5675 1.68451 12.1014 31.5323 -4.45098 -9712 4 12.5865 33.1501 1.03303 -8.81838 -7.47149 -8.20936 -9713 4 13.3352 34.4765 1.32576 -5.5291 -24.3721 14.4697 -9714 6 44.6567 10.4099 29.0319 -12.4525 3.56979 -21.9228 -9715 4 44.5737 9.45178 29.0051 9.95574 -3.72472 2.79876 -9716 4 44.0317 10.7133 28.332 10.7873 2.60441 13.9487 -9717 6 9.14585 24.5947 6.38022 15.9839 26.3438 -7.73853 -9718 4 8.92734 24.382 5.47582 -9.1117 -9.61509 -8.5024 -9719 4 9.72625 25.3768 6.21639 -5.50996 -10.1894 15.5503 -9720 6 52.5653 27.2618 21.6392 -6.48047 6.16108 13.4347 -9721 4 52.5564 26.3196 21.8908 4.78081 5.6644 -14.1528 -9722 4 52.8195 27.3969 20.7225 3.24319 -11.7343 -6.41363 -9723 6 7.29679 16.9603 33.544 -1.27463 2.76823 -11.9762 -9724 4 7.39152 17.7215 32.9493 2.03275 -0.910573 2.88066 -9725 4 6.37085 16.7082 33.4809 -4.66481 0.778096 -0.770576 -9726 6 43.9289 25.2227 7.97871 -4.96366 -10.0233 8.38699 -9727 4 43.2519 24.7308 8.49213 12.2574 5.67032 -8.3389 -9728 4 43.4276 25.9018 7.51862 -3.04483 5.5605 -3.23664 -9729 6 2.07953 27.1233 13.6028 0.0104954 7.16496 -8.77242 -9730 4 2.15896 26.2371 13.9627 -2.1358 -7.6126 6.04882 -9731 4 2.6502 27.1018 12.8141 -2.23666 2.89631 3.72058 -9732 6 37.3141 18.284 2.18477 -5.94753 -1.23785 7.60386 -9733 4 37.4961 17.5691 1.55591 -3.17432 -0.490531 -1.7774 -9734 4 36.7255 18.8979 1.7415 -3.03937 1.4219 -5.67571 -9735 6 25.0022 10.0655 0.429871 -30.1443 -7.37242 -0.593153 -9736 4 24.272 10.366 41.7528 14.2211 1.75124 5.05026 -9737 4 24.5705 9.40237 1.00583 14.7283 12.1051 -6.86513 diff --git a/examples/amoeba/dump.water_box.amoeba.1.test b/examples/amoeba/dump.water_box.amoeba.1.test deleted file mode 100644 index 9019401850..0000000000 --- a/examples/amoeba/dump.water_box.amoeba.1.test +++ /dev/null @@ -1,7227 +0,0 @@ -ITEM: TIMESTEP -0 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.67966 7.08769 17.9461 -18.0057 -16.954 4.82612 -2 2 7.80945 6.75579 18.2607 19.8034 12.4721 -7.17463 -3 2 8.72223 6.81424 17.0254 7.13784 0.0282027 3.08606 -4 1 18.5257 8.24445 6.83762 8.52147 14.2257 60.5703 -5 2 0.216892 7.89544 6.05003 12.0964 -15.6711 -53.3384 -6 2 0.444268 7.82601 7.5302 -13.3675 6.47926 -9.3119 -7 1 8.37906 18.5504 6.81463 24.6094 6.61103 -1.11969 -8 2 9.34042 0.098069 6.73406 -18.7879 -2.64022 0.747908 -9 2 7.93962 0.573676 6.26984 -2.09268 1.16699 2.67386 -10 1 6.58995 1.84432 11.7198 46.7475 -13.739 -10.5489 -11 2 5.88543 2.40231 11.9251 -37.1346 27.545 16.57 -12 2 6.18153 1.06275 11.3693 -7.36455 -17.4045 -5.52161 -13 1 7.1466 5.75358 2.33152 -53.3657 41.599 -1.38826 -14 2 6.36812 6.12603 2.86268 38.0857 -22.9036 -2.95785 -15 2 7.02502 6.29465 1.5182 16.1101 -20.4591 11.2904 -16 1 16.2164 10.1388 16.1382 -32.9296 19.8915 17.3579 -17 2 16.9509 10.2747 15.5847 32.6569 -1.09677 -20.2087 -18 2 15.8498 11.0405 16.2399 2.59134 -12.8635 2.30838 -19 1 10.6046 15.0374 2.30369 -9.45108 -28.933 -9.95229 -20 2 10.5292 14.3949 3.01849 1.67759 -0.529274 5.48943 -21 2 11.0236 15.78 2.70962 13.2591 21.3673 6.11781 -22 1 17.1624 8.24409 10.3708 10.41 5.9387 11.3227 -23 2 16.5528 8.68798 10.966 -4.81374 9.55532 3.583 -24 2 17.9421 8.82333 10.3208 -3.63548 -8.99367 -3.64514 -25 1 14.901 15.8652 16.3167 21.2892 -10.1645 16.79 -26 2 14.0225 16.1982 16.2525 -30.7371 12.6366 -7.00126 -27 2 14.9141 15.482 17.2099 1.64171 -7.21798 -3.7798 -28 1 12.1752 13.3771 0.408263 -10.449 7.39269 11.8256 -29 2 12.0579 13.8465 18.23 5.34035 -4.48355 -17.1718 -30 2 11.6217 13.8904 1.00796 2.45905 -0.157672 9.39156 -31 1 9.27358 5.34243 4.05546 -29.354 32.8373 13.3322 -32 2 8.64594 5.4665 4.83764 23.9402 -17.6274 -26.2044 -33 2 8.74177 5.68615 3.30282 4.39732 -15.4932 8.77495 -34 1 1.83016 4.27673 11.6495 -22.4867 33.9085 -11.1027 -35 2 1.70328 5.22377 11.9391 5.26663 -24.2909 -6.35354 -36 2 2.40811 3.85345 12.2597 16.6835 -12.3735 20.3319 -37 1 1.96438 6.83299 8.3731 -11.8866 6.09586 -26.8326 -38 2 2.49614 7.21578 9.0563 11.4719 0.0715494 18.6532 -39 2 1.81128 5.90585 8.57354 7.57659 -6.58781 5.32172 -40 1 5.40557 4.38899 7.93274 -5.84675 9.40812 -2.24834 -41 2 5.53738 3.43895 7.78131 -7.95286 9.95376 -0.129754 -42 2 4.75516 4.73491 7.29062 11.2407 -18.5615 7.61563 -43 1 3.23 2.92842 17.5524 1.14755 15.2746 17.0601 -44 2 3.93109 3.19827 16.9402 0.871842 10.3641 0.782189 -45 2 3.00444 3.70897 18.1497 2.9668 -26.2705 -22.3315 -46 1 7.4624 5.26283 6.13117 4.99569 4.7543 -2.87263 -47 2 8.02565 5.58849 6.88177 -21.8117 -10.641 -11.2175 -48 2 6.93508 4.45577 6.3254 15.5754 16.5621 10.3274 -49 1 9.77896 7.02384 11.9834 11.1892 -4.91774 24.9965 -50 2 10.2721 6.37256 11.5011 12.944 -11.2243 -3.64487 -51 2 9.1532 7.31587 11.3499 -25.3515 14.1302 -21.9158 -52 1 14.1167 3.54999 8.03003 -26.7224 -2.96987 -36.9282 -53 2 13.4732 4.22413 7.73132 14.0058 -9.36539 3.16858 -54 2 14.3809 3.80189 8.88487 12.5079 17.7406 36.8421 -55 1 4.82329 17.2568 4.03846 -17.1239 31.8599 -29.451 -56 2 5.49315 17.973 4.01308 -7.2715 -20.7015 10.2799 -57 2 4.18746 17.5412 3.33843 11.1391 -13.8034 10.6312 -58 1 16.4918 16.6259 10.0493 30.7319 18.7558 -40.9431 -59 2 16.1673 16.3226 10.8594 -24.9276 -14.9205 38.9888 -60 2 15.9925 16.2084 9.33562 -5.59472 -4.21747 7.16045 -61 1 1.94489 4.93323 0.49791 29.2037 9.87254 4.22328 -62 2 2.55322 5.26335 1.2053 -16.134 -9.14189 -14.6469 -63 2 2.08253 5.591 18.4408 -15.0883 -1.49688 2.64821 -64 1 11.816 13.3571 16.2711 -9.40148 3.94995 7.41554 -65 2 11.2371 12.6203 16.5671 11.2868 -0.226619 -16.3723 -66 2 12.2446 13.1893 15.4079 -8.93504 -7.51369 10.5349 -67 1 10.105 11.0651 16.9545 19.171 -30.5561 3.11717 -68 2 10.5674 10.1947 17.1295 -13.2328 27.8223 -6.21699 -69 2 9.25349 10.8067 16.5912 -4.96621 2.04172 2.74708 -70 1 11.7264 17.5421 13.4742 -3.04385 -27.7441 -11.1528 -71 2 12.2771 16.9836 12.8968 -5.80236 0.92931 5.24929 -72 2 12.1041 18.3936 13.317 3.92972 25.4072 2.69815 -73 1 6.33029 9.31911 12.2264 14.5686 -26.7823 -24.0739 -74 2 7.02603 8.96242 11.6353 -16.9594 2.64581 0.0898615 -75 2 6.81249 9.95941 12.7172 6.645 23.591 18.9185 -76 1 16.2187 12.7249 2.70186 -8.60429 -40.8729 7.98732 -77 2 17.0292 13.1566 2.50302 21.6794 20.3416 -10.6726 -78 2 15.4982 13.3357 2.61812 -11.4268 23.7847 2.88762 -79 1 0.637202 12.5625 5.84914 -31.8402 8.87564 3.58131 -80 2 0.892312 12.5507 4.90771 -4.9886 -2.92912 11.9697 -81 2 18.3039 12.804 5.85329 37.806 -5.77498 -8.15105 -82 1 5.19922 16.3781 18.5047 -8.79571 2.1563 -13.4584 -83 2 5.80284 15.8543 17.9455 2.86332 8.92403 13.1762 -84 2 5.67034 16.9636 0.462296 7.01287 -6.10758 -1.1835 -85 1 0.510145 7.62945 4.0545 45.1401 15.6351 -20.049 -86 2 18.5719 8.14656 3.45296 8.17292 -14.6601 7.70417 -87 2 1.46496 7.74082 3.66917 -48.4928 -0.554047 23.6518 -88 1 3.14672 8.89584 6.52626 -55.2927 3.32392 -1.46176 -89 2 3.50609 8.59991 7.35294 11.5609 -2.03159 9.82262 -90 2 2.14573 8.92962 6.68203 43.6989 0.357582 -10.1043 -91 1 7.30854 10.3037 16.1717 1.78466 -0.469392 13.5048 -92 2 6.56213 10.4624 15.5802 -0.177974 -0.17468 9.69093 -93 2 6.99303 10.278 17.1118 -1.93161 2.46429 -18.5659 -94 1 11.1122 1.06968 4.98939 -2.5529 -18.3754 16.0671 -95 2 11.0776 1.97142 4.64864 2.28669 -2.46607 -13.2595 -96 2 10.7048 0.433547 4.37027 3.43033 14.549 -3.59534 -97 1 4.45204 2.70061 13.2052 -5.66348 -30.5004 33.0628 -98 2 4.60333 3.05865 14.0914 -1.92534 16.2672 -14.1546 -99 2 4.38645 1.737 13.4626 -0.349226 19.9023 -23.5316 -100 1 8.42792 10.0237 1.78469 -10.3917 -19.899 15.7952 -101 2 8.3405 10.6377 2.53622 4.61332 0.207175 -2.25283 -102 2 8.49672 9.11244 2.17467 4.01989 28.7847 -10.326 -103 1 10.5335 1.75383 15.546 -34.1458 -0.453574 1.15961 -104 2 11.3977 1.82718 15.9216 24.1476 -5.37633 -0.0681618 -105 2 10.5608 1.78317 14.5837 3.50677 3.31298 -0.339701 -106 1 2.77693 12.941 7.74821 -10.4378 -0.583625 -1.53852 -107 2 3.28797 13.5733 7.23382 6.48403 3.62296 3.43855 -108 2 1.98704 12.8256 7.20013 3.29426 -8.64685 -0.0486837 -109 1 3.63517 11.6895 5.33963 -11.8109 -10.1864 -4.68879 -110 2 3.35385 11.0502 6.03137 5.66752 13.6786 -16.6554 -111 2 2.8758 11.855 4.74058 12.1084 -4.04172 11.1294 -112 1 6.88803 14.474 16.8428 -11.4129 11.5698 10.6698 -113 2 7.55973 13.8293 16.6383 5.64016 -3.74285 -2.32739 -114 2 6.60381 14.8838 16.0165 -1.10143 -9.42407 -1.70294 -115 1 14.1722 14.5374 3.41536 22.8916 -3.95473 -24.8295 -116 2 13.6514 15.2845 3.14096 -10.2906 15.0357 0.984662 -117 2 13.8512 14.2508 4.25439 -13.7068 -8.63673 17.9444 -118 1 8.28226 18.1809 16.0824 -12.751 -14.2632 -6.38017 -119 2 8.77677 17.3494 16.3071 3.86396 27.0257 -3.69586 -120 2 8.7603 0.384816 15.9919 13.8336 -15.3184 3.9152 -121 1 4.73724 1.61643 4.90111 4.42093 34.2728 -25.3552 -122 2 3.96969 2.16837 5.15263 7.5353 -10.5013 -8.47368 -123 2 5.18465 2.1484 4.15475 -16.3947 -25.6944 40.0476 -124 1 15.1457 12.8616 16.4403 -17.2871 -9.38827 44.2976 -125 2 14.6041 12.8692 17.2613 20.1997 8.40389 -10.3991 -126 2 14.49 12.6307 15.8136 -19.9308 -5.03226 -40.1466 -127 1 15.779 18.3837 16.786 46.4421 11.1965 42.4368 -128 2 16.5108 18.615 17.4688 -40.0732 -8.23978 -31.409 -129 2 15.7694 17.4186 16.7687 -10.9286 -0.13557 -0.275231 -130 1 1.1383 1.1331 16.5571 -3.78806 10.8903 6.59298 -131 2 1.96551 1.50352 16.9177 -13.4358 3.04324 -1.88802 -132 2 0.420521 1.53444 17.0916 18.9396 -8.74897 -5.5358 -133 1 18.0817 4.5907 15.863 15.5867 -18.8741 -0.0488223 -134 2 18.5818 3.91936 15.3489 -11.2031 15.1049 7.34982 -135 2 18.5602 4.7339 16.6874 -0.349245 -1.77666 -1.18458 -136 1 12.22 16.9378 16.1148 -5.50141 -11.6153 60.0453 -137 2 11.409 16.6934 16.6676 25.9686 4.83442 -31.2532 -138 2 11.9646 17.3216 15.2917 -16.184 2.10738 -25.7541 -139 1 15.8709 2.55221 17.9707 -0.937802 24.4841 -15.6355 -140 2 15.7355 3.48355 18.2574 7.57333 -26.0521 3.95198 -141 2 15.6659 2.59235 17.0072 3.66916 -5.77112 18.206 -142 1 6.70868 13.791 10.2637 2.56639 25.7323 0.00368182 -143 2 6.59347 13.548 11.1958 -0.357243 -4.92282 -5.01928 -144 2 6.58252 13.0514 9.6765 -3.72683 -17.1721 -0.802691 -145 1 10.146 18.2027 2.80372 18.7695 36.9578 -11.0057 -146 2 10.2207 0.331961 2.18345 -3.04248 -21.6078 13.7214 -147 2 9.26571 17.8868 2.67703 -19.5044 -8.44618 -8.21612 -148 1 2.97538 17.748 6.06078 -25.8303 0.797173 6.8887 -149 2 2.09399 17.6473 5.67013 0.763714 -3.05404 12.9421 -150 2 3.45883 17.8838 5.26396 31.3429 0.483929 -10.2997 -151 1 12.558 17.0134 7.97028 5.92903 -16.4499 -7.28316 -152 2 11.9572 16.2512 7.82085 0.921176 10.9238 13.6165 -153 2 12.4657 17.4524 8.83591 -10.9555 -3.32417 -4.29455 -154 1 14.8795 15.2862 8.28544 4.29768 -18.9738 42.4504 -155 2 13.9824 15.6136 8.40666 -1.92729 9.60106 -14.0248 -156 2 15.2312 15.4641 7.43118 3.9302 10.2131 -33.7787 -157 1 17.5429 18.3228 0.375372 -51.2916 -3.32975 -15.7386 -158 2 18.116 17.6308 0.128652 39.2354 -21.6017 -8.51882 -159 2 17.9698 0.288559 0.934677 25.0864 23.4945 21.3611 -160 1 0.910209 10.3712 1.41143 1.2541 -53.8465 46.4292 -161 2 0.158544 9.88347 1.87089 19.8792 18.5163 -27.3041 -162 2 0.565924 11.0969 0.944383 -23.7591 37.8535 -27.1782 -163 1 1.55407 12.175 3.31087 17.0236 24.8743 53.6813 -164 2 1.36245 11.4802 2.72234 -7.32763 -23.5838 -35.6732 -165 2 1.61623 13.0206 2.87285 0.136729 5.19924 -18.0355 -166 1 0.543127 17.2543 4.88609 31.8084 34.0538 -50.8525 -167 2 0.11032 17.9772 5.31124 -21.3387 12.8349 12.3342 -168 2 0.420366 16.4266 5.2673 -11.294 -44.4064 35.6607 -169 1 1.10053 1.01949 9.38768 20.2638 -3.47079 3.57058 -170 2 1.46081 0.575286 10.1589 5.67003 5.93636 13.5245 -171 2 0.265613 0.594128 9.34525 -28.6257 -3.15214 -10.2647 -172 1 16.8007 2.32783 13.2877 6.99662 17.0137 -29.7497 -173 2 17.0701 2.57314 12.3549 -10.9982 -8.19012 27.7721 -174 2 16.4263 1.43993 13.282 0.147057 -7.47121 1.20179 -175 1 2.45231 15.8283 12.1942 24.161 -10.1121 18.9704 -176 2 2.8623 15.5513 13.0537 -7.72007 6.59246 -26.0318 -177 2 2.91392 15.3801 11.4615 0.0476102 5.48907 2.61928 -178 1 16.435 15.531 5.9458 18.7492 36.0842 -19.2976 -179 2 17.3808 15.5177 6.20547 -11.8351 -4.55683 5.24266 -180 2 16.4147 16.2211 5.22063 -11.381 -14.928 22.2973 -181 1 5.84547 5.02056 11.8065 17.7106 -18.2202 -11.4458 -182 2 5.55799 5.91374 11.8891 -12.2572 20.16 10.1838 -183 2 5.09 4.45915 11.9819 -6.52029 -3.58907 3.63352 -184 1 15.2214 4.86555 0.731755 -13.1216 -14.4231 22.9417 -185 2 14.6776 4.45845 1.47821 22.203 16.7553 -20.5876 -186 2 14.6696 4.95834 18.5986 -12.3693 6.08689 2.65647 -187 1 16.3401 16.2933 2.11217 18.14 -13.9799 -32.9854 -188 2 16.0666 16.7695 2.87319 -13.0548 23.8975 25.5489 -189 2 16.7601 16.9279 1.50378 -12.2165 -0.858221 10.4248 -190 1 0.305885 4.87877 3.79118 -8.03527 51.7998 21.7755 -191 2 0.299338 5.85541 4.09758 -2.9952 -44.8334 -24.4202 -192 2 1.16991 4.5635 4.03062 6.79251 -10.5604 -0.715716 -193 1 2.92501 14.9782 15.0356 -0.55527 3.1583 33.427 -194 2 3.0159 14.7264 15.9987 -0.365372 -5.40078 -25.4532 -195 2 2.35392 15.7535 15.1247 4.98076 9.37108 -6.84819 -196 1 1.1115 14.5727 9.55731 53.2995 18.2393 -15.0567 -197 2 2.08491 14.4157 9.46275 -24.2978 21.5236 -5.71591 -198 2 0.897072 13.7408 9.90248 -27.8007 -35.1999 18.1171 -199 1 13.6501 16.6688 11.5433 6.47975 17.456 -8.04391 -200 2 13.4697 17.4567 10.9694 -3.73037 -22.0736 15.6897 -201 2 13.5721 15.8897 10.9842 -9.76738 -0.866763 -1.05724 -202 1 4.73098 1.47842 0.720986 0.301824 -3.12152 0.469647 -203 2 4.27169 1.98826 0.034225 -8.26683 -3.93854 8.43126 -204 2 4.11741 0.788607 1.06182 2.96071 12.6313 -1.58966 -205 1 1.42158 18.4663 11.9139 -14.1117 26.2958 -21.249 -206 2 1.21766 0.394331 12.6648 1.16138 0.455671 2.39682 -207 2 1.94844 17.765 12.2423 13.6408 -23.7742 11.0988 -208 1 11.5498 10.1018 4.11619 25.3456 17.7005 -19.3629 -209 2 11.5687 10.5955 3.24216 -3.14233 -16.3641 23.7483 -210 2 12.4899 10.1059 4.45555 -25.4417 -1.6091 -14.3563 -211 1 8.38254 12.182 3.76573 -28.852 -4.31545 3.66513 -212 2 9.25863 12.501 4.06076 -17.1001 4.9792 7.32521 -213 2 7.63736 12.4251 4.40785 39.3791 -3.23553 -14.7997 -214 1 14.3228 4.03714 3.29709 9.27375 -1.14036 13.2131 -215 2 14.8928 4.14179 4.10547 -9.51715 0.900554 -20.2647 -216 2 13.4701 4.45558 3.48891 4.64833 -1.13545 4.69814 -217 1 5.58188 1.78199 7.50513 -29.4992 -43.0538 46.7434 -218 2 5.0172 1.13958 8.12095 30.2312 35.5173 -41.7355 -219 2 5.33078 1.59122 6.59529 -0.079259 -3.9625 -11.0752 -220 1 17.9086 1.12503 4.88467 2.95857 -4.16946 -9.18468 -221 2 18.4038 1.54032 4.14207 -4.82318 -1.26447 16.1692 -222 2 17.6814 1.78344 5.55455 4.62183 1.86586 -4.7268 -223 1 6.83101 9.39303 4.49716 -16.0719 2.4093 -32.0921 -224 2 6.83675 9.57499 5.42715 5.68499 0.0447418 21.7322 -225 2 7.66807 8.99049 4.24996 11.5264 2.90932 7.40733 -226 1 2.71406 14.9654 1.962 -15.6661 -3.22344 -28.3015 -227 2 3.33343 14.7912 2.66354 12.1361 -6.91733 6.37301 -228 2 3.09502 14.6645 1.10257 -2.31521 10.6903 23.881 -229 1 17.279 12.8803 13.1283 -15.852 18.187 11.8592 -230 2 16.4044 13.2339 13.3283 -9.52452 -19.4408 0.302495 -231 2 17.6948 13.7346 13.0834 29.0619 4.95471 -11.8483 -232 1 15.0196 10.5818 1.38314 -38.2265 -36.9922 -31.977 -233 2 15.5102 11.1963 1.85791 34.2907 40.991 28.9525 -234 2 14.3351 11.0964 0.933298 3.32659 -5.3471 5.33786 -235 1 5.71789 6.95838 4.52856 0.683996 -27.8748 7.64407 -236 2 5.85266 7.87985 4.34179 3.58991 17.4746 0.820156 -237 2 6.44364 6.70841 5.13514 -10.315 -1.76088 -5.92415 -238 1 8.12142 8.26262 10.159 -0.695069 1.43108 44.445 -239 2 8.58519 8.93965 9.66877 7.60931 4.76567 -12.7632 -240 2 7.56021 7.74854 9.59836 -11.8614 -6.52029 -23.2391 -241 1 13.5311 18.2901 5.8079 -10.639 -13.2321 14.1155 -242 2 12.703 0.102298 5.56963 3.89465 4.4637 5.13268 -243 2 13.2939 17.6289 6.50758 1.00889 22.2284 -14.4481 -244 1 0.327324 2.56344 0.113251 1.70035 12.7901 -0.992224 -245 2 18.009 2.52214 18.5736 8.63965 15.9711 4.89881 -246 2 0.724331 3.48299 0.160564 -21.1536 -24.6374 0.514976 -247 1 12.6396 10.9599 9.76875 -56.8672 19.3176 -11.2335 -248 2 11.6552 10.7306 9.75031 35.1307 23.7735 -5.55284 -249 2 12.944 10.1383 10.0842 27.9729 -33.5927 10.4043 -250 1 0.789377 12.2851 11.08 11.4395 6.49483 14.2632 -251 2 18.4919 12.3017 11.2021 -18.2818 -3.30898 -6.09679 -252 2 1.09088 12.7637 11.8722 5.75277 -12.0493 -6.6955 -253 1 5.04567 7.2193 13.4912 -21.0137 -4.20407 -15.1033 -254 2 5.59899 7.84649 13.0247 8.33052 12.0635 4.31379 -255 2 5.48047 6.97898 14.3058 12.3979 0.954472 8.53674 -256 1 1.28609 6.99027 11.837 -51.8154 -68.8711 -15.2848 -257 2 0.481329 7.14037 11.2978 13.8945 0.267944 10.341 -258 2 1.71601 7.79102 11.8803 31.2664 60.1884 9.92158 -259 1 15.4442 9.46712 12.3088 17.5832 34.764 29.4487 -260 2 15.6103 10.4448 12.4444 -11.1607 -30.7672 -13.8763 -261 2 15.5582 9.10301 13.208 -6.74487 -0.409264 -16.2653 -262 1 16.6404 12.9744 5.44078 0.476019 -21.9889 6.56196 -263 2 16.2955 13.8866 5.54247 3.20084 -14.9841 -16.6056 -264 2 16.51 12.593 4.54035 -6.85686 22.0547 12.2483 -265 1 6.17495 10.0683 0.210584 -24.8048 -7.78292 -31.6597 -266 2 5.35839 10.4511 0.557392 3.36584 -0.936069 -2.46609 -267 2 6.76092 10.0813 0.943985 27.7338 0.90169 16.297 -268 1 12.3644 6.05734 4.04236 -18.3706 -38.3329 30.2118 -269 2 12.4738 6.70802 3.38308 -4.23006 32.9396 -25.2938 -270 2 11.4212 5.77124 4.03221 17.6012 8.78206 -0.800798 -271 1 0.124733 12.8266 0.203961 3.20067 -1.28022 -4.47052 -272 2 0.029974 13.5935 0.786871 -4.13202 -3.19163 0.984476 -273 2 18.185 12.9963 18.0877 7.32574 2.49628 4.77591 -274 1 3.83931 18.5785 8.61972 20.3146 -6.32916 -11.386 -275 2 3.58625 18.36 7.70531 -8.03976 -3.33875 5.01892 -276 2 3.07994 0.282626 9.06556 -19.534 7.19375 -0.404578 -277 1 7.37599 17.2741 4.45241 46.8945 31.0513 1.9622 -278 2 8.02493 17.9603 4.76808 -26.2103 -24.7083 -3.79352 -279 2 7.47725 17.3636 3.49301 -14.0292 -8.10987 6.13371 -280 1 9.20909 17.0315 12.2197 40.0448 -1.21715 18.2255 -281 2 9.48765 16.172 11.8421 -14.9023 11.2095 -3.08284 -282 2 9.99892 17.2887 12.7762 -22.6762 -6.36186 -10.9913 -283 1 13.3284 13.0292 7.94175 -54.0325 -32.963 -10.3586 -284 2 13.0533 12.253 8.47808 14.6554 7.99008 1.85075 -285 2 14.1985 13.2855 8.14946 35.8516 11.3519 14.341 -286 1 14.9871 2.94126 15.3478 14.8638 12.3357 -7.44451 -287 2 14.2243 2.52816 14.9303 4.35222 -7.49481 -2.56315 -288 2 15.7054 3.02501 14.6718 -19.1947 -5.47381 11.1555 -289 1 9.85637 15.4939 17.0026 4.34281 7.61827 -6.92944 -290 2 10.2013 14.6312 16.7411 4.19591 2.79737 -1.68983 -291 2 9.35728 15.3668 17.8085 -9.66212 -2.87408 7.84053 -292 1 11.2848 8.23994 16.5492 3.25751 34.7591 1.5155 -293 2 10.8315 7.75123 15.8747 -12.3664 -15.1549 -6.58201 -294 2 11.7506 7.62533 17.1016 5.33248 -14.8245 8.28699 -295 1 3.77097 18.1898 16.7118 4.01905 33.5947 11.0152 -296 2 4.24576 17.6768 17.3569 8.65949 -22.0954 6.28955 -297 2 3.7978 0.441972 17.1008 -4.25038 -14.6471 -12.4326 -298 1 2.20581 4.09889 8.95874 2.08991 2.93543 4.28652 -299 2 3.00197 3.55544 8.74643 -14.7124 14.9899 14.3923 -300 2 2.10364 4.24367 9.94001 10.2614 -16.6264 -23.5165 -301 1 9.9196 10.3581 9.75231 -25.3187 14.4865 -18.1673 -302 2 9.34403 11.1055 9.40387 23.5511 -18.6954 16.391 -303 2 9.87032 10.282 10.7171 2.48436 10.3271 -7.39297 -304 1 9.73405 0.807167 10.8572 20.2474 21.386 4.54274 -305 2 9.58177 18.5811 11.2204 -17.7151 -14.7389 -0.277185 -306 2 9.10878 1.03014 10.1675 -11.7891 -3.63679 -6.29284 -307 1 9.18221 15.2247 10.2123 -13.9791 -9.46207 -17.3808 -308 2 9.04674 16.0847 9.7631 0.486754 -17.6411 9.75771 -309 2 8.3908 14.6843 9.94105 18.1048 12.7648 16.7376 -310 1 1.00316 9.27987 10.329 16.2357 -30.0069 -12.307 -311 2 1.16727 10.1904 10.5724 12.5584 13.4462 -0.132091 -312 2 1.84996 8.76119 10.1498 -29.1191 35.4904 9.82697 -313 1 16.8004 4.89338 8.19813 20.3933 -12.8673 28.5682 -314 2 16.1748 5.31624 8.83318 13.8703 -8.22156 -17.3769 -315 2 17.4877 4.38941 8.71628 -28.7666 17.1718 -13.9408 -316 1 14.6379 14.6893 0.402347 -11.3933 -1.08114 12.583 -317 2 14.9609 15.3376 1.05877 1.73558 -10.8431 -5.12344 -318 2 13.9048 14.1906 0.841144 16.133 14.0369 -13.7985 -319 1 3.51181 11.0525 9.63829 3.71178 7.51059 -9.42611 -320 2 3.41507 11.3617 10.5484 4.21267 3.5616 -2.2445 -321 2 3.25155 11.8076 9.06383 -1.86739 -11.3951 3.16022 -322 1 11.0289 10.8695 1.26208 17.5529 18.9634 -6.32419 -323 2 11.1535 11.716 0.753779 -2.53448 -25.7082 13.9861 -324 2 10.1142 10.5923 1.16471 -5.76816 1.63272 -1.45278 -325 1 13.2239 7.06188 12.8977 -31.5053 10.0751 -2.41927 -326 2 14.1381 6.84046 12.8922 27.4331 -7.40558 0.979603 -327 2 12.7471 6.22139 12.9668 2.74296 5.12722 -5.48309 -328 1 9.62584 1.88878 0.937813 20.2039 -2.98483 37.6532 -329 2 8.77484 2.11506 0.623903 -27.5663 2.83673 -14.773 -330 2 10.1764 1.70882 0.191067 9.03311 -1.803 -18.3794 -331 1 10.6054 13.537 4.7508 -5.88392 -4.211 -2.61457 -332 2 11.3208 12.9359 5.04367 -2.43279 15.5075 -5.53386 -333 2 10.4128 14.1619 5.47507 10.6777 -11.2442 -5.71889 -334 1 14.2525 1.6915 10.8868 22.6682 20.2673 6.9187 -335 2 15.0842 1.26497 10.6465 -0.175006 -8.05208 -4.1062 -336 2 14.5069 2.62992 10.8824 -12.4791 -0.486299 1.09093 -337 1 14.6678 12.4248 11.7157 -13.2082 -11.6835 -6.16669 -338 2 15.5574 12.5766 11.3177 -21.8957 -10.6844 -5.73724 -339 2 14.0022 11.9667 11.1187 29.6297 15.7618 7.64488 -340 1 8.24065 5.08218 9.78509 -6.47861 44.5837 29.4664 -341 2 7.45364 5.10173 10.3836 14.047 -11.9893 -18.2698 -342 2 8.36822 4.22882 9.41503 -9.58488 -33.9934 -8.19516 -343 1 1.59893 16.8132 18.3262 1.96117 45.1636 -18.3395 -344 2 1.99225 17.1675 17.4932 -11.7114 -3.37836 17.8399 -345 2 1.72693 15.8931 18.2458 8.8364 -33.8164 2.61771 -346 1 1.43382 17.2563 15.3383 72.5903 -10.7327 -13.0674 -347 2 1.32309 18.1562 15.5759 -7.01853 28.114 11.2541 -348 2 0.623143 16.841 15.3782 -65.0193 -20.0106 1.99827 -349 1 3.73599 5.55499 6.2196 -15.153 37.171 -3.6345 -350 2 3.32092 6.26594 6.76194 -0.427016 -18.6419 -6.59332 -351 2 4.19567 6.05321 5.52665 9.16489 -2.39818 -0.177123 -352 1 12.357 9.41487 14.1826 14.7553 -23.0333 -0.513454 -353 2 12.9591 8.63784 13.9021 -31.7094 29.7183 13.6876 -354 2 11.936 9.15457 15.0346 15.6336 0.764049 -11.787 -355 1 4.0362 15.2647 6.90572 29.1452 22.7898 -8.55589 -356 2 3.45744 16.0249 6.7945 -6.03593 0.633302 -6.25525 -357 2 4.92941 15.6518 6.66696 -24.7672 -22.8121 8.07817 -358 1 0.606517 8.56128 14.8606 8.16327 11.3924 -6.42857 -359 2 0.498099 9.52604 14.9437 -1.3098 -5.53798 5.35752 -360 2 1.28855 8.50016 14.167 -7.84877 -5.15776 5.22176 -361 1 12.9763 8.3683 10.3434 -0.844759 8.90572 -31.1716 -362 2 13.7163 7.90436 9.89822 -4.62341 -2.31264 17.3373 -363 2 12.9003 8.0957 11.2534 8.39581 -13.8091 14.665 -364 1 15.2983 7.63672 3.47583 -36.1974 -22.3868 30.0346 -365 2 14.5024 7.10501 3.29647 15.8969 13.8763 -24.8874 -366 2 15.2922 7.47095 4.43335 27.1257 13.219 -1.62631 -367 1 17.3208 6.63818 0.028906 -14.8751 21.4285 -7.11338 -368 2 16.7479 6.05403 0.554933 2.23596 0.744461 -7.2242 -369 2 16.7141 7.27151 18.2009 9.57247 -21.991 17.917 -370 1 8.79355 6.92545 7.84172 -22.0329 -24.5159 21.3067 -371 2 9.63968 7.32585 7.85068 36.717 16.3192 -5.46325 -372 2 8.77688 6.39871 8.67404 -5.56167 6.19415 -17.3543 -373 1 12.3209 0.607808 1.1741 -8.60043 -0.59496 -5.94607 -374 2 12.995 1.15082 1.58835 11.0262 -7.11766 4.69751 -375 2 12.79 18.5825 0.66073 -1.01688 3.73434 3.9163 -376 1 5.68514 15.097 14.5145 8.08213 26.2607 -13.8654 -377 2 4.72797 15.1695 14.4772 -8.65505 -1.66018 8.38379 -378 2 6.02476 15.8935 14.032 -4.56821 -16.9623 16.8148 -379 1 3.822 6.53853 1.67803 10.5239 -7.29529 -10.476 -380 2 3.54968 7.33117 1.17576 -0.94291 -9.86176 19.1013 -381 2 3.81642 6.7886 2.60252 -1.1437 7.90849 5.70077 -382 1 3.89262 11.6088 12.227 12.6183 0.535598 5.61903 -383 2 4.72051 12.1032 12.348 1.21499 -6.42147 -0.654839 -384 2 3.26281 12.0921 12.7526 -15.9809 8.56892 5.74885 -385 1 5.45444 3.88172 15.8755 8.44756 62.1439 23.7417 -386 2 5.90627 3.24049 15.3708 26.1603 -31.2362 -14.1171 -387 2 6.11665 4.65725 15.9739 -35.5554 -35.0069 -5.06549 -388 1 14.4636 10.317 4.39501 5.54347 -18.2961 -43.8287 -389 2 14.9051 9.88853 5.13417 0.162303 -5.91623 3.64337 -390 2 14.7084 9.81768 3.53446 -11.8135 21.0668 42.8202 -391 1 7.94949 17.2895 9.24469 -10.6799 8.8199 -1.02562 -392 2 7.23447 17.5423 9.86969 8.35341 2.50468 -15.9799 -393 2 8.01085 17.8889 8.47627 -8.2125 1.31495 9.33291 -394 1 4.4986 14.4237 3.96317 23.4879 4.54475 27.495 -395 2 4.89523 15.3318 4.14709 -14.6852 -27.1979 0.729547 -396 2 4.80237 13.7713 4.67129 -11.1841 28.5155 -20.9146 -397 1 14.3358 7.38467 15.7635 18.2582 5.36164 1.70543 -398 2 15.2401 7.23754 15.391 -25.5283 4.5174 14.2628 -399 2 14.4998 7.83446 16.6232 -7.00614 -11.7321 -15.3353 -400 1 2.86875 18.2246 1.90934 11.7547 29.7641 47.6357 -401 2 2.54447 17.7626 1.17928 -20.4445 -34.8995 -41.4626 -402 2 2.08284 18.4154 2.45796 12.4063 3.86937 -8.17484 -403 1 7.96139 1.61197 4.52525 30.3503 -5.61589 29.1814 -404 2 7.4985 1.83317 3.72811 -5.85178 12.6793 -14.6648 -405 2 8.84188 2.051 4.57628 -22.8061 -6.44347 -10.2559 -406 1 2.69247 14.1251 17.7583 -44.9975 -8.30966 9.027 -407 2 1.78944 13.8074 18.0556 29.9332 0.951363 -12.1679 -408 2 3.33089 13.517 18.1683 -0.885538 6.08231 -6.55793 -409 1 0.711797 1.68055 13.8626 46.1903 -0.903658 -18.4125 -410 2 0.854596 1.56791 14.7929 -3.1534 -4.53792 18.4431 -411 2 18.4557 1.86826 13.7064 -36.4408 7.03813 3.66844 -412 1 4.5582 18.5986 13.9691 16.7448 -5.62304 -20.7496 -413 2 5.37614 18.0918 13.7297 -17.5024 17.6116 13.2075 -414 2 4.4096 18.4453 14.9034 -5.9637 -5.97884 8.59903 -415 1 7.10973 0.453475 18.3742 -15.9095 45.4284 35.234 -416 2 6.99644 0.098599 17.5235 1.36411 -17.312 -40.4978 -417 2 6.34312 1.05085 18.5323 11.251 -17.9428 -0.916775 -418 1 16.0934 18.4421 14.1505 -12.1616 -21.5095 -38.715 -419 2 15.444 17.7866 13.7542 19.2119 24.6311 23.4234 -420 2 16.0379 18.4915 15.109 -11.392 0.0248185 1.48898 -421 1 10.1156 4.52417 16.2956 -62.1497 -10.7811 -30.3439 -422 2 10.9808 4.34247 16.5381 55.5233 -0.530433 19.4573 -423 2 9.84863 3.69679 15.8473 1.30878 12.8229 10.5952 -424 1 15.8226 17.9425 4.41327 -8.6596 2.53656 28.4341 -425 2 16.5547 18.5732 4.53052 -7.53986 -1.28134 -1.76301 -426 2 15.1071 18.2295 5.06915 24.8326 -13.5436 -35.3744 -427 1 6.9246 17.3574 13.7412 35.4232 12.1969 -4.79491 -428 2 7.49648 17.8115 14.4369 -19.095 -19.6264 -17.6052 -429 2 7.52703 17.1963 12.9658 -8.44681 6.90552 21.4872 -430 1 13.2892 6.57209 6.73437 -47.4462 -6.01427 11.894 -431 2 14.2146 6.66317 6.83486 37.5911 0.460957 -13.6759 -432 2 13.0394 6.38579 5.82242 8.60231 0.411312 -6.48828 -433 1 7.6616 2.3861 9.17526 11.1339 -5.58665 -35.6695 -434 2 7.32169 2.39592 10.0555 -17.0215 -5.04529 20.6135 -435 2 6.95914 2.1022 8.53308 18.7558 7.43711 21.2842 -436 1 15.1464 14.8771 13.6482 -7.73724 1.21311 0.537171 -437 2 15.0308 15.0223 14.6069 -1.84691 1.26092 -11.2626 -438 2 14.3194 15.1152 13.1798 14.9291 -3.65447 11.731 -439 1 9.29105 8.34315 3.70472 21.3149 -22.535 5.81715 -440 2 10.1776 8.75859 3.73678 -10.082 3.55323 2.49013 -441 2 9.48378 7.39942 3.88081 -6.26995 14.6936 -2.40173 -442 1 17.6854 13.4687 16.4528 7.27147 30.461 -18.2669 -443 2 16.7357 13.4337 16.3398 -4.89197 -8.49248 4.47316 -444 2 17.8844 14.3284 16.0065 3.65909 -18.1112 10.9221 -445 1 5.04883 10.6547 2.58751 22.4142 -14.5409 3.1837 -446 2 5.87017 10.3468 3.04382 -22.783 5.18619 -3.79272 -447 2 4.55197 11.1441 3.22928 -6.35653 9.92745 13.9967 -448 1 3.70566 8.3683 10.3381 0.421872 -35.3081 -1.7593 -449 2 3.86061 9.29726 10.2176 3.60826 23.2513 -1.90293 -450 2 3.86652 8.14601 11.2715 -1.83662 8.64514 -7.63686 -451 1 16.1079 7.11641 6.33859 18.7251 -13.7954 -9.96454 -452 2 16.7241 7.70559 6.80408 -7.87205 -5.85527 -7.24175 -453 2 16.6678 6.33083 6.12136 -22.8952 10.0887 6.36104 -454 1 15.2027 7.00502 9.1117 -13.5711 31.2066 -33.9348 -455 2 16.009 7.42176 9.46585 -10.2898 -7.03399 -7.73296 -456 2 14.9881 7.51375 8.25647 13.8068 -20.3115 41.0185 -457 1 6.4525 13.1649 12.9201 -16.9811 1.25576 1.12717 -458 2 7.2977 12.7289 13.0561 1.55279 -4.02118 8.73008 -459 2 6.25327 13.7237 13.7059 9.12735 -9.15034 -19.1848 -460 1 12.1145 4.49786 13.0694 62.3048 41.2439 -0.723073 -461 2 12.3852 4.68406 13.9868 -14.3297 -10.0558 -0.292641 -462 2 11.3952 3.9317 13.0199 -52.2119 -35.1204 4.15665 -463 1 11.3323 8.18365 7.8522 27.7169 3.03613 12.328 -464 2 12.0901 7.73501 7.43634 -12.9205 -4.29619 -7.69129 -465 2 11.7651 8.45102 8.68662 -18.4456 -0.736999 -3.04515 -466 1 17.1666 10.776 7.42179 36.4822 -17.3878 -25.363 -467 2 17.7906 10.0723 7.08441 -17.5934 13.4566 22.3886 -468 2 17.2793 11.4524 6.73733 -15.3427 2.84073 7.18141 -469 1 5.22802 18.1471 11.05 -23.1388 -14.8798 2.48444 -470 2 4.73762 18.1049 11.901 7.4508 0.565766 -17.6495 -471 2 4.62535 17.7417 10.374 17.7336 12.8347 12.9373 -472 1 7.56653 17.6363 1.80821 4.35794 -3.26776 57.5888 -473 2 7.65741 16.7768 1.42856 9.05039 -19.6913 -22.9027 -474 2 7.35855 18.2549 1.13994 -1.37991 13.1573 -30.1972 -475 1 1.85092 12.9256 13.6076 18.7065 20.702 19.2299 -476 2 1.72104 12.4156 14.4258 -5.54537 -0.960406 -11.4426 -477 2 2.19932 13.7866 13.9501 -8.88955 -22.8153 -6.43965 -478 1 9.73868 6.79159 14.8001 -20.0718 45.6966 0.235719 -479 2 9.95236 5.95211 15.1529 12.0129 -40.6355 11.2206 -480 2 9.967 6.84408 13.8723 5.59208 -5.10263 -8.66058 -481 1 15.2087 4.3972 10.7794 -27.6923 -26.0969 -27.5028 -482 2 16.0082 3.89203 10.8637 26.1176 6.2885 5.33656 -483 2 15.2102 5.16148 11.3322 8.48984 16.211 19.3779 -484 1 11.1963 6.12482 0.150068 -21.1972 -23.7011 14.8212 -485 2 11.2381 5.20796 0.481504 11.4486 12.9471 -10.1704 -486 2 10.2374 6.21547 18.6186 14.0424 14.8346 -3.67395 -487 1 0.19533 11.3359 15.1413 -20.6703 11.3325 -28.7309 -488 2 18.4021 11.874 14.3993 9.91215 -19.3636 27.3138 -489 2 18.4481 11.661 15.9631 4.36494 9.01906 -3.16307 -490 1 7.06882 9.13032 7.26059 -19.4655 -1.24154 14.8953 -491 2 6.55985 8.40099 7.69941 12.6354 16.9737 -16.1687 -492 2 7.9725 8.82922 7.21375 8.43039 -5.65083 0.275054 -493 1 18.4578 15.4507 12.3537 3.87705 -1.0699 -4.92487 -494 2 0.776651 15.5698 12.2511 -12.7177 -2.03387 6.80581 -495 2 18.1456 15.6789 11.4721 -4.67377 -0.406651 0.743757 -496 1 16.5694 4.36967 5.25107 0.98709 -29.8421 42.9348 -497 2 16.7744 3.81151 6.06026 -19.0257 27.4778 -23.1846 -498 2 17.3898 4.32671 4.78168 15.572 7.21618 -21.1326 -499 1 17.788 3.06911 10.7078 7.64381 16.9425 17.2861 -500 2 0.075758 3.1322 11.0257 -14.4921 -2.82201 -9.29777 -501 2 17.6332 2.20749 10.3226 4.29805 -13.9207 -6.70838 -502 1 12.3142 0.064083 10.1758 -16.2036 46.6093 2.93236 -503 2 11.3746 0.384648 10.259 24.7548 -16.9496 1.0795 -504 2 12.8178 0.919304 10.3228 -10.1981 -36.9052 -8.89593 -505 1 10.3666 9.83315 12.2981 10.0643 6.74252 24.9843 -506 2 11.1015 9.85063 12.955 -7.48254 2.69098 -11.3777 -507 2 10.1328 8.91188 12.2898 -1.25875 -17.3524 -2.69444 -508 1 0.463654 2.82678 7.01839 23.1504 30.9543 10.494 -509 2 0.875324 3.58845 7.48211 -15.8261 -9.71426 -11.3384 -510 2 0.770257 2.12665 7.58365 -2.51696 -19.6875 3.88184 -511 1 0.478371 15.2358 6.91004 -5.36214 -57.1351 9.88058 -512 2 0.585298 15.6463 7.75647 2.33624 13.0536 15.0713 -513 2 0.556531 14.2524 7.18353 -2.6234 48.5984 -27.3232 -514 1 16.9534 7.00251 15.3394 -19.8576 7.98442 -8.98385 -515 2 17.6338 7.63543 15.0899 18.202 -5.57661 4.9227 -516 2 17.3093 6.19568 15.7235 12.2576 0.0838452 -6.46227 -517 1 9.0001 12.4151 8.13768 -31.7276 34.3494 27.7642 -518 2 9.37386 11.8218 7.49742 -2.69042 -17.0115 -24.8182 -519 2 8.02402 12.632 8.03373 37.271 -17.4326 -7.14384 -520 1 1.27238 1.95406 3.05803 -14.2139 -9.70678 -17.9319 -521 2 1.26084 2.61511 2.34121 0.72572 -7.36998 11.1944 -522 2 1.89031 2.22344 3.73293 7.71835 10.2015 -2.21509 -523 1 4.13907 15.1156 9.62039 -24.138 8.67184 14.727 -524 2 4.07003 15.1439 8.65747 7.76366 -2.53025 0.663124 -525 2 4.96029 14.7006 9.86457 16.019 -6.11163 -3.79055 -526 1 7.17628 2.17866 14.5671 8.05543 15.8774 -0.750343 -527 2 6.99528 1.68402 13.7698 -4.08254 -5.57585 -6.74919 -528 2 7.62131 2.98432 14.249 -3.31184 -9.11349 9.13274 -529 1 18.6082 14.7131 2.1481 32.1263 -19.3615 -2.59353 -530 2 0.838003 15.1297 2.25966 -2.55576 -5.62694 -3.02712 -531 2 17.988 15.3544 2.42675 -29.4597 23.3621 5.14018 -532 1 9.94138 2.79524 12.9422 18.0301 -20.084 -2.65944 -533 2 9.79404 2.1456 12.2228 -2.72579 10.1868 5.0837 -534 2 9.17835 3.36299 13.0326 -9.76513 7.42125 -6.32672 -535 1 2.80444 8.90955 13.0076 -21.3878 -12.6555 -0.633582 -536 2 3.06361 9.80599 12.872 11.8276 24.8177 -4.92621 -537 2 3.5122 8.48618 13.4775 16.8101 -10.8298 6.5617 -538 1 3.236 8.3574 3.63664 -3.24123 -25.7508 65.6997 -539 2 3.45085 9.0718 3.07326 14.699 31.6407 -15.7982 -540 2 3.47645 8.58669 4.60794 -10.8292 -3.55345 -46.4885 -541 1 5.62853 7.18594 8.51094 13.0444 23.9613 2.26298 -542 2 5.46784 6.31815 8.13889 -4.11832 -12.799 10.1434 -543 2 4.96415 7.47792 9.15047 -6.22666 -11.1251 -0.517113 -544 1 14.8757 1.26039 2.01768 6.89853 7.12439 -27.6668 -545 2 14.9353 2.01952 2.56559 -6.08088 15.4811 28.5729 -546 2 15.2784 1.60993 1.21235 -3.12956 -15.001 -5.59525 -547 1 8.22892 15.2012 0.850139 9.01324 -8.86779 5.43529 -548 2 9.02213 14.9338 1.33488 4.41045 13.1537 -1.08033 -549 2 7.55366 14.6663 1.27665 -10.9347 0.418265 -6.06235 -550 1 15.6387 1.34587 7.23673 -34.4855 -14.424 -6.72803 -551 2 14.9277 0.724731 6.91269 25.2779 16.6902 6.4887 -552 2 15.1173 2.1119 7.53894 8.3028 -0.775331 -5.89355 -553 1 4.90142 13.0959 18.5232 17.5611 -6.682 24.5871 -554 2 5.32755 13.082 0.76977 -9.23128 1.69535 -18.7742 -555 2 5.44764 13.7122 18.0259 4.92611 -3.73779 -6.82361 -556 1 15.3368 8.46948 18.1479 24.407 23.6523 -18.6734 -557 2 15.8061 9.12264 17.5623 -15.0725 -19.5419 9.94084 -558 2 15.3318 8.91689 0.353875 -7.67765 1.6761 7.06822 -559 1 12.0708 3.01842 18.3809 -8.57811 34.9919 -15.9288 -560 2 11.9316 2.65996 0.60646 7.37996 -15.8634 5.79137 -561 2 12.6022 2.47389 17.7995 4.55547 -17.8211 5.72515 -562 1 13.2139 12.6752 5.17768 -11.8856 9.18106 -10.9384 -563 2 13.7464 12.0348 4.69253 2.29692 -7.56952 8.05888 -564 2 13.2564 12.5123 6.11793 11.0077 -2.72782 9.02039 -565 1 6.05443 7.0356 0.031519 0.145276 -19.8641 5.27909 -566 2 5.93935 7.95118 18.5019 2.68887 36.361 -1.99394 -567 2 5.39095 6.86665 0.702638 -10.5375 -11.3291 0.555603 -568 1 17.7528 16.0276 15.0213 -26.9751 8.08167 9.65398 -569 2 16.9476 16.5457 15.105 2.62193 -2.13449 20.9775 -570 2 17.7479 16.0055 14.0813 23.0391 -15.2709 -33.7916 -571 1 13.196 0.994907 16.5363 6.64944 3.5152 15.0268 -572 2 14.1481 0.997912 16.7614 -13.0846 -5.94027 -6.50206 -573 2 12.8833 0.094199 16.7238 3.13951 3.25376 -8.62791 -574 1 11.1253 14.5647 7.20271 12.6179 20.8985 -18.374 -575 2 10.4007 14.3183 7.72981 -32.928 -10.0181 24.5345 -576 2 11.7186 13.8255 7.26943 16.9686 -3.76464 3.70387 -577 1 17.5081 8.62849 2.08107 18.4536 39.9223 21.5452 -578 2 16.6801 8.63471 2.55495 -14.8656 -12.3201 1.9096 -579 2 17.5233 7.88242 1.516 -5.44609 -31.2556 -23.2052 -580 1 12.3547 8.01168 2.02213 3.34817 7.10659 0.607451 -581 2 12.2384 8.8582 1.54611 -2.17098 -11.1853 7.9144 -582 2 11.9739 7.3152 1.48261 -5.38076 0.52639 -15.2068 -583 1 11.8761 14.6165 10.3364 1.47614 -26.5661 -12.796 -584 2 12.1004 13.7873 9.81464 -15.4397 33.1565 21.8304 -585 2 10.8993 14.6888 10.473 20.8283 -4.95583 -12.7008 -586 1 6.89524 7.05211 15.6117 0.948881 6.37495 10.6055 -587 2 7.81004 7.26536 15.3122 -15.6925 -0.985911 8.93516 -588 2 6.66676 7.54167 16.4408 13.3623 -9.35483 -24.2683 -589 1 8.00326 4.73593 13.4743 46.4542 16.9938 22.3473 -590 2 7.23337 4.7302 12.9572 -38.0428 3.58552 -28.1525 -591 2 8.40671 5.62958 13.343 -10.0413 -24.497 3.68285 -592 1 13.4128 12.1818 14.2522 -5.09814 -0.706424 13.2965 -593 2 12.9414 11.3292 14.2657 9.08717 -0.174959 -7.02282 -594 2 13.7875 12.315 13.3696 0.74786 -2.13255 -0.749325 -595 1 14.8395 9.42189 7.30548 -8.6508 -34.4179 -15.7659 -596 2 15.7087 9.765 7.42505 16.3683 18.0856 5.12693 -597 2 14.2269 10.0768 7.57319 -16.6679 19.7312 11.3719 -598 1 12.6526 17.0686 3.07252 -27.098 39.8252 10.9251 -599 2 12.8376 17.5237 3.93373 4.63929 -18.9198 -22.9156 -600 2 11.9913 17.6958 2.63477 30.4514 -31.1971 13.898 -601 1 1.15545 7.13838 17.4647 3.17244 9.59861 -23.4243 -602 2 0.330359 7.36323 17.9184 0.96629 -9.78644 0.159833 -603 2 1.05514 7.47868 16.5422 0.732192 -3.11516 17.9471 -604 1 12.7562 5.15096 15.6457 43.4314 -6.34677 13.892 -605 2 13.4512 4.55662 16.0315 -22.7809 11.2033 -14.7919 -606 2 13.2414 6.00335 15.5788 -11.6166 -6.13865 2.23982 -607 1 2.53993 3.38757 4.97618 -22.6627 40.6834 48.2045 -608 2 1.7609 3.18232 5.58922 26.9518 1.19035 -20.1247 -609 2 2.84154 4.31546 5.27885 -5.90416 -46.089 -11.2441 -610 1 8.33186 11.2983 13.4548 -26.6082 5.68838 43.1719 -611 2 8.4244 11.0562 14.4444 7.75654 0.873515 -50.9507 -612 2 8.91168 10.8786 12.8197 22.3442 -13.0535 12.4472 -613 1 12.8689 1.31514 13.3384 2.90045 58.5941 -12.9641 -614 2 13.42 1.58034 12.5659 -7.54964 -19.9936 10.3698 -615 2 12.4231 2.17844 13.5496 8.73522 -32.0886 -3.11014 -616 1 6.34008 13.7169 2.14963 -18.1698 -8.87317 18.5321 -617 2 5.63978 13.877 2.82959 15.2612 6.49493 -20.3543 -618 2 6.88351 13.0442 2.56282 10.2537 -4.17084 0.110729 -619 1 15.9206 6.61444 12.7992 -24.6515 -28.5257 0.353752 -620 2 16.3106 7.25195 12.2393 18.8127 19.5603 -18.6955 -621 2 16.4213 6.59661 13.608 8.17022 1.84551 14.3752 -622 1 16.8298 0.712824 9.59482 4.92561 -19.6459 1.56363 -623 2 16.8791 18.3713 9.72616 -6.7933 22.7031 -2.37673 -624 2 16.5452 0.8605 8.67269 -3.47063 -2.57745 5.28583 -625 1 6.14624 11.7631 8.37671 0.810232 -55.5778 6.71556 -626 2 5.32447 11.4591 8.84151 13.2611 12.3623 -11.7456 -627 2 6.64226 10.8931 8.20176 -18.8432 36.5086 0.169281 -628 1 2.88754 8.61261 0.453821 16.629 -12.4076 -25.9584 -629 2 2.45212 8.04764 18.3917 -7.9132 30.8844 23.5565 -630 2 2.34875 9.28564 0.895642 -16.9187 -4.58083 -11.1609 -631 1 10.1674 10.4623 6.50123 2.03347 0.962837 -14.0367 -632 2 10.6087 9.69731 6.89122 -0.033473 -1.16532 5.68604 -633 2 10.4694 10.4636 5.56932 -4.02396 0.831062 14.2442 -634 1 6.7142 15.6951 6.55167 21.2433 7.58031 13.0519 -635 2 7.14328 16.1838 7.27089 -7.64643 -7.38759 2.93585 -636 2 7.21237 16.006 5.79102 -10.2318 7.90387 -13.7372 -637 1 6.445 13.1807 5.57797 -4.95716 -23.6388 -1.26087 -638 2 6.7301 13.9465 6.07331 -1.77634 9.04977 6.94523 -639 2 6.09943 12.5433 6.22286 1.34041 6.33507 -0.553394 -640 1 16.8242 12.5629 9.83758 4.06472 -20.7324 4.78658 -641 2 16.9985 11.8651 9.16533 -5.27225 15.8277 3.76725 -642 2 16.5644 13.3844 9.42716 1.03985 5.07871 -11.9 -643 1 6.03738 2.95058 2.86354 -7.03855 -25.5492 -1.19629 -644 2 6.40977 3.757 2.57075 15.9289 34.7492 -4.17594 -645 2 5.57703 2.61747 2.09059 -4.9021 -9.32473 -6.53819 -646 1 10.9114 3.33767 3.30112 5.22699 -4.50477 6.26496 -647 2 10.297 4.02722 3.58926 -1.95634 -6.20434 -4.73409 -648 2 10.5127 2.84524 2.57795 -5.80356 2.60284 -4.41077 -ITEM: TIMESTEP -10 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.68613 7.08001 17.9478 -7.01358 -5.91592 2.73538 -2 2 7.77987 6.83016 18.2266 16.0785 4.58355 -9.56375 -3 2 8.81561 6.77572 17.042 -2.60158 -2.67368 4.89818 -4 1 18.5411 8.25019 6.8397 -3.31911 20.0829 53.2463 -5 2 0.132112 7.95881 5.98338 15.0803 -17.7916 -37.9407 -6 2 0.419079 7.77779 7.52768 -3.57438 0.834533 -17.4022 -7 1 8.38502 18.5543 6.8162 17.8503 9.74549 -0.663478 -8 2 9.33656 0.12202 6.71165 -15.3958 -3.25669 1.14423 -9 2 7.91896 0.595612 6.31609 0.0971505 0.0480551 2.20998 -10 1 6.59239 1.84347 11.7106 33.6248 -3.3918 -11.5419 -11 2 5.88602 2.36507 12.0365 -24.0057 14.4643 13.3031 -12 2 6.19621 1.03555 11.4016 -9.54455 -15.1367 -3.43817 -13 1 7.13469 5.75647 2.33282 -16.0707 1.2807 18.6339 -14 2 6.47472 6.10605 3.02238 22.3175 -2.25238 -34.2201 -15 2 7.09016 6.23688 1.47486 -10.0175 -2.52095 21.7818 -16 1 16.2156 10.1493 16.1334 -27.9935 4.46583 14.8083 -17 2 17.0011 10.2168 15.6173 19.2784 7.57164 -10.1711 -18 2 15.8457 11.0427 16.2776 9.29404 -6.61316 -4.9073 -19 1 10.6069 15.0238 2.30809 -6.31705 -20.7544 -7.43742 -20 2 10.5597 14.4327 3.07214 -0.102442 0.508968 4.74876 -21 2 11.0526 15.7982 2.62807 10.1844 15.1967 6.36644 -22 1 17.1594 8.2489 10.3903 7.52685 0.546464 5.9579 -23 2 16.5819 8.79937 10.9325 -0.0424193 4.91704 3.34034 -24 2 17.9857 8.74574 10.257 -6.36369 -4.03495 0.916497 -25 1 14.8922 15.8683 16.3299 23.5339 -10.8154 7.03311 -26 2 14.0097 16.1903 16.2206 -28.4756 7.26009 1.81472 -27 2 14.9055 15.3621 17.1614 -4.45807 1.9077 -0.883551 -28 1 12.1657 13.3863 0.41518 7.67499 -13.0963 13.9948 -29 2 12.1102 13.7181 18.1579 -7.06431 5.66946 -3.72811 -30 2 11.6673 13.9211 1.04936 -4.85696 8.50836 -7.81927 -31 1 9.27628 5.36844 4.05123 -34.192 4.59602 9.65195 -32 2 8.65917 5.24858 4.84371 24.3198 3.71877 -28.2857 -33 2 8.65376 5.51218 3.29446 11.8948 -3.58803 14.2972 -34 1 1.82985 4.27304 11.6494 -12.5424 24.0017 -6.14821 -35 2 1.72713 5.22025 11.9335 1.67264 -20.3932 -8.37626 -36 2 2.38183 3.84857 12.2925 10.2742 -10.1374 14.5925 -37 1 1.96666 6.8371 8.3675 -1.07206 -9.37897 -7.64517 -38 2 2.48137 7.16021 9.09528 7.6819 14.0614 11.7347 -39 2 1.91994 5.89719 8.57067 -2.65468 -6.85216 -5.3032 -40 1 5.40566 4.39875 7.93795 -15.0212 -10.7202 -17.6012 -41 2 5.47911 3.43644 7.82861 5.00513 7.47325 10.3929 -42 2 4.74947 4.60653 7.2496 8.53973 6.88839 10.8311 -43 1 3.24286 2.9209 17.5475 -3.50993 31.6723 15.8788 -44 2 3.91538 3.33593 16.9792 1.14815 -4.85754 -1.50754 -45 2 2.90196 3.68515 18.1088 4.46159 -27.603 -16.229 -46 1 7.46543 5.27113 6.11173 -0.267366 -14.8618 42.036 -47 2 7.89952 5.61794 6.92737 -2.28349 10.3868 -28.0837 -48 2 7.00366 4.5014 6.50229 0.780861 12.0869 -17.1147 -49 1 9.7753 7.01959 11.9799 12.4421 -0.327694 33.7281 -50 2 10.3285 6.37932 11.5448 5.34489 -7.46932 -11.0014 -51 2 9.14168 7.33293 11.3548 -18.5265 5.10994 -23.2436 -52 1 14.1114 3.54906 8.03925 -21.2079 2.70274 -24.764 -53 2 13.5379 4.24737 7.67406 9.42135 -8.95765 0.532077 -54 2 14.4057 3.90023 8.85862 11.8721 11.0917 26.6467 -55 1 4.80077 17.263 4.02669 -14.2573 4.92943 -10.2324 -56 2 5.55275 17.8868 4.11075 -15.7048 -9.31229 -6.31173 -57 2 4.21849 17.485 3.25536 16.798 3.03083 13.1086 -58 1 16.5008 16.6241 10.052 9.35033 0.377019 -20.0251 -59 2 16.0742 16.3966 10.8515 -13.0635 -0.25069 32.9814 -60 2 15.9476 16.1716 9.40786 2.84148 0.00630379 -7.36632 -61 1 1.95698 4.92664 0.48601 10.6785 6.17321 -0.923017 -62 2 2.54546 5.28332 1.19783 -10.1544 -3.94981 -19.1082 -63 2 1.86706 5.64777 18.4726 -0.259245 -4.73099 10.3692 -64 1 11.8035 13.3621 16.2801 -12.0315 -31.2076 -16.8087 -65 2 11.3006 12.5351 16.4295 -1.37085 13.2186 10.8936 -66 2 12.2283 13.1244 15.4353 5.36339 15.8055 8.10642 -67 1 10.1086 11.0623 16.95 16.2363 -23.6439 1.11167 -68 2 10.572 10.1938 17.105 -14.3776 22.5927 -6.24497 -69 2 9.21542 10.8357 16.6616 -0.160324 -0.0991661 2.29857 -70 1 11.7231 17.5369 13.4667 -11.0418 -25.624 2.08744 -71 2 12.2825 16.9797 12.896 1.06573 10.1819 1.6514 -72 2 12.0497 18.4302 13.3866 8.679 12.3703 -3.21063 -73 1 6.34404 9.31427 12.2267 -10.7289 -25.2447 -16.4149 -74 2 6.95388 8.98312 11.5319 -2.39052 10.1346 10.7157 -75 2 6.76108 10.0063 12.722 17.2241 14.9443 4.4156 -76 1 16.2191 12.7237 2.7003 -6.42998 -13.8373 4.3175 -77 2 16.9936 13.1939 2.44509 26.0904 7.71252 -7.79508 -78 2 15.5637 13.4111 2.72948 -20.2851 11.8065 3.04981 -79 1 0.635855 12.5646 5.86231 -29.6975 10.9384 -12.0161 -80 2 0.906184 12.4779 4.92975 2.15237 -1.21985 12.1118 -81 2 18.3245 12.8391 5.75844 29.6273 -11.2198 7.31028 -82 1 5.19222 16.3868 18.4948 24.5889 -0.529385 -6.85369 -83 2 5.88953 15.8781 18.0466 -13.534 -2.69513 -2.10794 -84 2 5.71609 16.8872 0.480999 -10.5805 4.6302 6.45748 -85 1 0.515864 7.62939 4.0653 41.0474 19.9956 -23.6294 -86 2 18.5677 8.05158 3.40199 9.2753 -7.28591 11.0746 -87 2 1.47269 7.84683 3.73678 -46.4137 -9.00167 19.6367 -88 1 3.14217 8.89553 6.52533 -39.0459 6.50689 -6.5056 -89 2 3.57285 8.63007 7.33767 0.0694837 -1.26665 5.56399 -90 2 2.14756 8.93745 6.67407 38.5311 -3.64433 -0.906695 -91 1 7.31414 10.3036 16.1763 -22.1518 3.21861 21.8391 -92 2 6.53268 10.4772 15.6415 8.43374 -0.0418936 -5.11234 -93 2 6.92709 10.2964 17.0866 13.3044 -2.27208 -10.5118 -94 1 11.1096 1.06093 5.00144 -6.80657 -2.48033 -19.8934 -95 2 11.1672 1.90146 4.5306 6.84499 7.0717 9.43568 -96 2 10.7236 0.515071 4.29558 2.64862 -9.02148 12.7331 -97 1 4.44354 2.70015 13.2121 -7.85281 -5.62302 -11.5877 -98 2 4.59136 3.20795 14.0303 0.103412 -15.4758 0.294405 -99 2 4.3686 1.71349 13.3622 2.85998 26.6352 12.1157 -100 1 8.41457 10.0307 1.78829 1.66015 -12.4273 17.1623 -101 2 8.40835 10.6665 2.53096 -1.47245 -0.417386 -5.09881 -102 2 8.60407 9.1525 2.20287 -3.10051 22.5249 -10.5265 -103 1 10.5229 1.75436 15.5533 -10.8574 -2.31 -4.36647 -104 2 11.4367 1.69676 15.8141 13.1269 -3.82494 7.61076 -105 2 10.5487 1.84704 14.5957 -9.26118 2.80358 -1.94415 -106 1 2.76968 12.9399 7.75003 -7.62511 -10.5749 7.18171 -107 2 3.32023 13.5874 7.29614 -2.30989 2.01815 -3.81018 -108 2 2.03946 12.7099 7.15165 5.79412 3.19458 -2.23462 -109 1 3.64251 11.6901 5.3273 -16.0178 -10.9709 -3.95767 -110 2 3.35804 11.041 6.0007 8.31372 10.277 -11.7948 -111 2 2.86611 11.8409 4.75105 13.6859 -0.281218 5.78901 -112 1 6.88155 14.4797 16.8524 -8.387 2.95998 -0.938339 -113 2 7.57426 13.8507 16.6622 5.60788 -2.76391 3.60002 -114 2 6.54738 14.7428 15.9834 -3.14908 -1.19839 3.78249 -115 1 14.1759 14.5423 3.40785 14.1775 -0.803279 -11.9449 -116 2 13.6583 15.316 3.2037 -5.78511 13.0134 -4.56688 -117 2 13.7723 14.1777 4.18517 -7.95121 -12.1195 11.7606 -118 1 8.26975 18.1784 16.0718 57.0984 -9.85256 5.13508 -119 2 8.90468 17.4721 16.3223 -30.0265 -6.05197 -2.08742 -120 2 8.93252 0.246004 16.0158 -21.102 13.2242 -8.22396 -121 1 4.73201 1.6168 4.90814 8.59128 29.3629 -19.7592 -122 2 3.91099 2.13549 5.04668 12.4977 -9.17326 -4.88478 -123 2 5.26431 2.14928 4.23236 -22.3039 -21.7635 28.9569 -124 1 15.1182 12.8405 16.4381 19.169 -3.61406 36.631 -125 2 14.6612 12.9963 17.2965 -1.87916 -0.605635 -21.6052 -126 2 14.5331 12.7051 15.7087 -30.2626 -2.71441 -16.8094 -127 1 15.786 18.3864 16.793 25.1295 13.8681 33.7963 -128 2 16.4578 18.6099 17.5315 -31.6416 -14.5347 -31.3905 -129 2 15.6162 17.4305 16.8164 1.02724 4.80811 3.46398 -130 1 1.14089 1.13731 16.5539 1.05247 19.7088 19.8175 -131 2 1.92337 1.60495 16.9036 -3.97271 -4.80748 -10.3705 -132 2 0.461096 1.48073 17.164 6.66439 -11.1518 -10.5802 -133 1 18.0862 4.58432 15.8734 11.1688 -12.2484 -2.69667 -134 2 18.5694 3.95442 15.2994 -8.21946 11.4291 8.6944 -135 2 18.5872 4.69164 16.6898 0.203498 -2.64567 -2.95902 -136 1 12.2303 16.9505 16.1288 -38.2728 -13.2591 26.8237 -137 2 11.3888 16.5791 16.5378 36.1694 7.82178 -3.50336 -138 2 11.9114 17.1502 15.2549 6.78701 5.10115 -22.4581 -139 1 15.8814 2.54765 17.9709 5.97775 7.55467 -0.319093 -140 2 15.7733 3.43717 18.3784 -1.8513 -17.3861 -11.5789 -141 2 15.6471 2.5946 17.0126 2.53833 6.86428 19.1803 -142 1 6.70799 13.8021 10.253 -1.58408 1.43394 8.76454 -143 2 6.59288 13.5189 11.1728 1.36627 8.87991 1.27306 -144 2 6.58321 12.9942 9.75946 1.30239 -6.02422 -13.3165 -145 1 10.1413 18.2148 2.80353 9.44086 30.3012 -19.3156 -146 2 10.2266 0.305071 2.14691 0.267733 -14.8877 14.3982 -147 2 9.27777 17.8669 2.60695 -13.096 -6.5965 0.845742 -148 1 2.97176 17.7529 6.06326 -6.30899 -0.645097 35.0899 -149 2 2.08427 17.6133 5.69483 9.57331 2.68214 -12.771 -150 2 3.63239 17.8017 5.37586 1.28926 -2.69105 -18.2517 -151 1 12.5668 16.9974 7.96757 -20.2971 -18.5655 21.3419 -152 2 11.8856 16.2971 7.95074 9.26888 3.31932 -10.856 -153 2 12.3344 17.4798 8.78306 11.437 7.92329 -7.28752 -154 1 14.8861 15.2795 8.28974 -15.7554 0.3814 10.2226 -155 2 14.0374 15.7294 8.25106 -5.80199 2.88483 11.5438 -156 2 15.1981 15.4683 7.42207 26.2963 -2.4275 -26.3232 -157 1 17.5473 18.3112 0.374559 -18.2134 -6.45531 -4.6775 -158 2 18.2634 17.761 0.12213 22.8374 -25.4457 -15.3465 -159 2 17.9951 0.303427 0.894204 5.3706 29.2695 18.8411 -160 1 0.910079 10.3754 1.4141 -19.386 -45.7403 28.0244 -161 2 0.0926857 9.86966 1.69283 27.9138 11.9581 -5.7438 -162 2 0.554372 11.07 0.90565 -10.4877 37.4892 -28.5805 -163 1 1.56425 12.1843 3.32385 10.4497 17.8757 14.7846 -164 2 1.39557 11.5297 2.67534 -6.58566 -33.3087 -13.0061 -165 2 1.62643 12.9551 2.76927 3.66066 18.4363 0.784965 -166 1 0.55148 17.2559 4.87768 14.7947 16.704 -22.83 -167 2 -0.0171494 17.9122 5.24737 -12.9669 22.3753 -0.718336 -168 2 0.416337 16.5086 5.40997 -1.38762 -39.6682 22.4532 -169 1 1.10468 1.00284 9.3945 22.843 10.0615 -6.85845 -170 2 1.39907 0.698807 10.2625 -7.65597 -6.79115 6.92044 -171 2 0.213465 0.701839 9.27091 -15.6194 -8.53979 4.03703 -172 1 16.7947 2.33154 13.2859 2.87858 8.18604 -25.1476 -173 2 17.0129 2.55787 12.3417 -6.42954 -5.0835 25.2497 -174 2 16.4749 1.41822 13.3005 0.0523867 -3.46078 1.59731 -175 1 2.46566 15.827 12.1934 26.7468 -10.5365 13.2985 -176 2 2.93451 15.5288 13.0073 -9.90545 6.65681 -19.023 -177 2 2.95128 15.4495 11.4346 -3.9234 5.36807 1.6728 -178 1 16.4371 15.5461 5.94503 -4.66267 19.6238 -8.97399 -179 2 17.3612 15.5093 6.28134 -9.63254 6.93473 -7.38316 -180 2 16.3109 16.2991 5.29174 10.2179 -16.1602 20.4085 -181 1 5.84392 5.02209 11.7979 1.85982 -4.44524 -6.98506 -182 2 5.51366 5.87933 12.041 -2.35542 15.5447 8.97079 -183 2 5.10963 4.44446 12.0068 -1.26359 -10.5886 0.396425 -184 1 15.2223 4.8645 0.724291 -23.0156 -11.391 23.7803 -185 2 14.7624 4.52384 1.55825 21.1304 12.2284 -22.5635 -186 2 14.5125 5.05103 18.7394 0.751055 2.39009 4.23042 -187 1 16.343 16.2984 2.11648 10.3227 5.9227 -27.7144 -188 2 16.0112 16.8052 2.83865 -11.2354 10.0489 28.078 -189 2 16.6417 17.0002 1.51324 -1.84363 -9.29214 0.277829 -190 1 0.300695 4.8777 3.79796 -11.7144 38.8206 3.66766 -191 2 0.319109 5.88664 3.94702 6.24107 -45.2605 -6.61048 -192 2 1.15751 4.50056 4.01017 2.49534 2.82459 2.96224 -193 1 2.92353 14.9884 15.0405 10.7548 -7.33568 16.7257 -194 2 2.98085 14.609 15.9661 -8.47597 15.0336 -19.5599 -195 2 2.47925 15.8529 15.1074 -0.728265 -0.613609 8.13891 -196 1 1.11951 14.5697 9.5576 17.0302 46.4745 -20.2694 -197 2 2.08903 14.5584 9.38425 -20.4257 -12.3501 8.75388 -198 2 0.805573 13.7616 9.91809 5.52927 -28.6811 10.8766 -199 1 13.6617 16.6633 11.5459 -10.7506 10.3565 -21.4971 -200 2 13.3218 17.4276 11.0158 5.92664 -14.8533 17.3679 -201 2 13.3915 15.8986 11.0154 -3.11899 -0.859159 7.39997 -202 1 4.73366 1.47986 0.719369 -25.3145 -4.02421 3.51446 -203 2 4.15092 1.98399 0.125941 8.58395 1.79335 0.854136 -204 2 4.09918 0.853913 1.13528 12.7275 2.9151 -0.0185569 -205 1 1.42442 18.4742 11.9045 -6.93945 20.4545 -13.991 -206 2 1.2372 0.390371 12.6666 -0.822965 2.19478 3.53324 -207 2 1.89543 17.725 12.2367 7.95706 -17.4489 5.30436 -208 1 11.5469 10.1058 4.11116 26.1716 14.4711 -26.2735 -209 2 11.5284 10.5631 3.21886 -3.69376 -13.1884 23.9867 -210 2 12.5118 10.0773 4.36205 -26.1062 -0.534026 -7.20275 -211 1 8.37237 12.1712 3.75254 -13.3709 24.5961 46.1376 -212 2 9.17249 12.5936 4.11701 3.41223 -8.92861 -19.033 -213 2 7.75234 12.4533 4.48752 5.20668 -18.7884 -32.053 -214 1 14.3233 4.03204 3.29282 11.0049 6.10018 19.4579 -215 2 14.9517 4.19348 4.04461 -8.72763 -4.53117 -18.7735 -216 2 13.4979 4.46304 3.56838 3.12416 -1.49393 -3.31976 -217 1 5.58139 1.77074 7.50691 -36.613 -47.7339 30.604 -218 2 4.96189 1.1025 8.02564 35.7201 38.4984 -27.3817 -219 2 5.38779 1.57566 6.57729 1.13697 3.96791 -6.02851 -220 1 17.9042 1.1171 4.88471 6.84957 17.1887 -7.45832 -221 2 18.4571 1.56865 4.21188 -4.6905 -14.0516 5.22121 -222 2 17.737 1.81424 5.53024 -1.96776 -6.02251 3.4729 -223 1 6.82733 9.39684 4.48845 1.87187 -0.890058 -10.0607 -224 2 6.84716 9.53076 5.42818 -7.08772 5.76802 18.8049 -225 2 7.72364 9.08838 4.32443 4.93667 -1.85919 -9.57362 -226 1 2.70107 14.964 1.9632 9.79064 -8.50271 -23.1477 -227 2 3.33865 14.7342 2.63816 0.0868029 -0.794049 11.9475 -228 2 3.17782 14.7454 1.13419 -13.4 8.87294 12.5953 -229 1 17.2782 12.8964 13.1387 8.1593 -36.3772 6.82198 -230 2 16.3556 13.1177 13.3173 4.03584 18.7537 -2.31465 -231 2 17.8303 13.6552 12.9439 -8.38561 20.0322 -1.78655 -232 1 15.018 10.5797 1.38541 -30.6488 -33.8734 -22.7761 -233 2 15.5405 11.2097 1.82354 25.6355 33.1541 21.1587 -234 2 14.2986 11.0703 0.97193 1.92599 -0.723232 4.24038 -235 1 5.71261 6.94641 4.5266 2.6516 -23.4686 10.5302 -236 2 5.87991 7.88124 4.41392 4.1014 10.4162 -0.896017 -237 2 6.40034 6.62744 5.14459 -6.91809 0.316355 -6.72793 -238 1 8.10894 8.26231 10.1757 -1.61977 4.99166 17.0229 -239 2 8.63366 8.87039 9.65704 12.8257 12.1371 2.09156 -240 2 7.5873 7.82886 9.51802 -16.026 -14.2044 -11.4362 -241 1 13.5265 18.2929 5.80397 -22.7677 -1.43199 15.791 -242 2 12.744 0.210577 5.63003 6.52185 -0.137688 -2.34328 -243 2 13.224 17.7307 6.55929 8.82644 11.7072 -16.2211 -244 1 0.31998 2.55606 0.111337 -23.7151 48.4906 1.53453 -245 2 18.006 2.70756 18.6319 7.21623 -15.3908 0.76394 -246 2 0.639493 3.49242 0.214062 7.71863 -30.3236 1.31164 -247 1 12.6438 10.9651 9.76843 -27.6007 42.776 -15.0826 -248 2 11.6462 10.8587 9.68427 36.5826 -6.8361 3.61513 -249 2 13.0097 10.1328 10.024 -0.792921 -29.0746 6.76076 -250 1 0.78357 12.2825 11.0843 20.7577 -6.91251 -2.74458 -251 2 18.4749 12.2741 11.1385 -12.0685 2.84404 7.0736 -252 2 1.15918 12.6384 11.9096 -11.1326 -3.84191 -3.75479 -253 1 5.04379 7.22322 13.4829 1.39832 5.89977 -6.97466 -254 2 5.58123 7.93479 13.1271 0.448534 7.96016 -10.0051 -255 2 5.53384 7.00565 14.2746 1.03136 -7.66768 11.7435 -256 1 1.27874 6.97532 11.834 -32.074 -43.2189 -14.0481 -257 2 0.482678 7.18669 11.3131 10.1443 0.561183 6.98996 -258 2 1.70367 7.78255 12.0103 18.1825 36.8435 9.31001 -259 1 15.4541 9.47267 12.3132 5.88964 23.7827 6.22024 -260 2 15.5166 10.4677 12.3686 -5.40153 -30.7713 4.20372 -261 2 15.4815 9.07432 13.2056 -1.6395 12.2138 -11.1334 -262 1 16.6425 12.9485 5.45228 -24.7761 13.2233 -32.5849 -263 2 16.3124 13.8685 5.42836 11.1894 -7.98651 20.9726 -264 2 16.4187 12.7313 4.52305 11.1313 -16.3356 15.5726 -265 1 6.1733 10.0557 0.193027 -12.4899 -11.5053 -32.3049 -266 2 5.38495 10.4604 0.58061 6.43577 -0.470902 4.897 -267 2 6.88008 10.1049 0.827544 12.5305 3.42311 14.2724 -268 1 12.3659 6.05415 4.04188 -22.1763 -21.8278 15.5685 -269 2 12.3683 6.79715 3.46108 4.13216 24.0909 -16.7914 -270 2 11.421 5.79287 4.05326 15.4186 -0.211849 3.77561 -271 1 0.132582 12.8231 0.203992 -0.195483 1.63508 -4.90635 -272 2 -0.0245094 13.5503 0.825031 2.49545 -1.98409 0.771993 -273 2 18.2458 13.055 18.0666 5.13636 -1.5464 3.82803 -274 1 3.83888 18.5816 8.61379 -9.81831 -4.88162 -16.6552 -275 2 3.52001 18.2631 7.75085 8.43173 -4.7192 1.01067 -276 2 3.03206 0.305129 8.96677 -7.80256 7.43459 9.99927 -277 1 7.39556 17.2738 4.45596 16.9172 12.0122 12.5371 -278 2 7.99849 17.9848 4.79149 -15.6229 -16.9846 -19.2965 -279 2 7.33818 17.3251 3.48629 6.36463 5.57381 8.87833 -280 1 9.21998 17.0388 12.2284 15.8258 3.83046 11.207 -281 2 9.35195 16.1931 11.7423 2.16771 12.8413 7.7779 -282 2 10.0104 17.2216 12.8137 -16.5375 -11.854 -19.0408 -283 1 13.3184 13.0063 7.94019 -19.3301 -32.807 5.85066 -284 2 13.1883 12.2647 8.56801 -4.60418 3.91603 -7.64254 -285 2 14.1459 13.3708 8.19821 21.3317 21.1541 5.11013 -286 1 14.9844 2.95035 15.3504 8.07249 -1.73557 -24.8008 -287 2 14.3 2.40675 14.9389 -0.805511 -1.63288 7.60525 -288 2 15.6705 2.98762 14.6436 -9.05507 2.69068 16.8604 -289 1 9.85476 15.5033 17.004 5.70996 8.22456 -10.0233 -290 2 10.2769 14.6753 16.7296 0.407564 1.12786 2.5917 -291 2 9.2992 15.3275 17.7693 -4.49302 -4.18434 5.79618 -292 1 11.2887 8.25054 16.5462 4.3815 15.8935 1.4126 -293 2 10.7498 7.72178 15.9677 -11.4268 -3.01506 -11.0903 -294 2 11.7109 7.60541 17.1026 7.03572 -6.39426 11.2088 -295 1 3.78312 18.1923 16.7229 -8.20319 16.8802 -14.09 -296 2 4.23544 17.5706 17.2928 8.99584 -2.65396 14.876 -297 2 3.78517 0.451969 17.0887 5.65759 -16.2586 2.71634 -298 1 2.1977 4.10819 8.95021 24.5715 -13.8141 31.6135 -299 2 3.03624 3.61916 8.82088 -15.7399 12.2693 -11.2697 -300 2 2.14197 4.07166 9.94067 -11.3718 7.67499 -23.2123 -301 1 9.90974 10.3516 9.73776 -22.8793 37.5197 3.40937 -302 2 9.44348 11.1923 9.4561 16.1923 -27.4723 -0.755713 -303 2 9.93951 10.4177 10.7077 4.76489 -7.47333 -8.73237 -304 1 9.73601 0.810068 10.8572 -6.50885 -0.835519 -1.39877 -305 2 9.40585 18.6129 11.1735 2.22486 -11.7661 13.7712 -306 2 9.0915 1.01857 10.1847 -1.93261 14.5334 -11.6688 -307 1 9.19364 15.2092 10.2107 -23.0073 -10.2994 -8.74256 -308 2 8.9841 16.0542 9.76587 1.98806 -14.8547 5.4661 -309 2 8.35152 14.6762 10.1166 22.3916 12.2872 5.93767 -310 1 0.995532 9.29186 10.3281 47.9462 -2.63812 -8.64675 -311 2 1.22741 10.2031 10.5086 -13.3799 15.5027 2.96196 -312 2 1.9063 8.9262 10.1621 -35.7029 0.949407 3.82346 -313 1 16.813 4.88766 8.1932 11.5161 -10.5322 32.9144 -314 2 16.1615 5.34773 8.77307 11.8935 -6.11126 -18.0819 -315 2 17.4051 4.37395 8.80041 -19.6267 13.8505 -17.9411 -316 1 14.6429 14.6942 0.394535 -7.00543 -1.89626 8.24203 -317 2 15.0463 15.2494 1.09531 -2.64327 -9.316 -7.76003 -318 2 13.8679 14.2346 0.794348 15.878 11.3494 -8.58286 -319 1 3.51953 11.0524 9.63262 1.11689 7.20138 -8.56155 -320 2 3.49309 11.4422 10.5196 2.01858 0.130954 -3.30783 -321 2 3.17116 11.7397 9.0203 2.67149 -7.88535 6.47818 -322 1 11.039 10.8616 1.27104 8.39953 16.0658 -8.46941 -323 2 11.1885 11.6907 0.750788 0.782166 -19.893 14.3131 -324 2 10.1072 10.6419 1.14889 -0.773464 -1.49716 1.06219 -325 1 13.2204 7.07184 12.8933 -24.0174 5.01566 -6.09093 -326 2 14.1394 6.83939 12.9167 20.0602 -3.76028 0.39046 -327 2 12.7464 6.22555 12.8749 2.49778 2.97258 -0.29329 -328 1 9.62856 1.88969 0.946546 9.2636 -0.931103 20.1878 -329 2 8.76541 2.02695 0.593353 -22.3319 -0.80038 -4.92587 -330 2 10.1675 1.74594 0.181071 13.2226 0.132969 -11.6901 -331 1 10.5934 13.5316 4.73807 16.1446 0.574492 13.3086 -332 2 11.4317 13.0614 4.94174 -10.7106 3.3069 -14.0299 -333 2 10.5321 14.1207 5.51129 -4.24994 -4.20037 -10.3127 -334 1 14.2715 1.70318 10.8964 -1.77809 5.91235 7.28652 -335 2 15.0728 1.25501 10.5853 5.24738 9.35157 -1.74174 -336 2 14.4034 2.67095 10.8772 7.32957 -6.49183 -2.39775 -337 1 14.6603 12.4192 11.7243 1.91159 -25.2344 -56.6412 -338 2 15.4845 12.4874 11.1931 -4.23005 7.1619 22.5795 -339 2 14.0903 12.0081 11.0211 -1.48986 11.1607 31.5891 -340 1 8.24886 5.08654 9.79134 -29.2123 3.64284 23.7692 -341 2 7.42109 5.02927 10.3149 15.0309 17.1198 -4.03621 -342 2 8.23121 4.21184 9.43797 12.1669 -22.8524 -17.3047 -343 1 1.59528 16.8201 18.3251 -4.66834 32.7155 -7.23976 -344 2 1.93304 17.2062 17.488 -5.12416 -8.69561 13.5025 -345 2 1.82608 15.9028 18.3034 8.21551 -19.1337 -3.40609 -346 1 1.44054 17.2474 15.3375 38.2305 -7.16391 -6.50211 -347 2 1.35107 18.1379 15.6308 4.79859 24.8425 9.12518 -348 2 0.562777 16.9452 15.3387 -39.5261 -18.284 -3.02502 -349 1 3.72855 5.57524 6.20331 -9.94128 10.6794 2.05156 -350 2 3.21297 6.20603 6.76334 9.83918 -6.42931 -13.7589 -351 2 4.29894 6.06824 5.5848 -3.89827 7.08279 4.15512 -352 1 12.3545 9.42683 14.1827 20.4014 -41.9092 8.4814 -353 2 12.8623 8.59837 13.88 -21.4785 35.8512 3.66034 -354 2 12.0611 9.1345 15.077 2.36507 11.6403 -12.9904 -355 1 4.03327 15.2744 6.905 24.5442 3.45717 -5.69457 -356 2 3.46314 16.0225 6.67296 5.01039 2.15408 -3.12402 -357 2 4.97164 15.5268 6.67147 -27.9532 -4.4537 7.17357 -358 1 0.606997 8.56433 14.8637 1.00605 -0.185347 4.59471 -359 2 0.51054 9.52697 15.0006 4.18475 -5.95105 -3.81642 -360 2 1.25745 8.45601 14.1476 -5.10421 5.72757 5.73964 -361 1 12.9756 8.36618 10.3398 20.3701 -17.1189 -10.5242 -362 2 13.727 7.8435 10.0036 -6.14808 8.99881 -11.6124 -363 2 12.9675 8.02293 11.2263 -11.3517 2.56625 21.5008 -364 1 15.2884 7.63693 3.49378 10.1588 18.7913 -12.1111 -365 2 14.5458 7.1482 3.08376 7.93209 -0.245397 21.6039 -366 2 15.5211 7.50792 4.43838 -15.1505 -14.5868 -6.72816 -367 1 17.3202 6.64717 0.0328861 -29.9623 13.6257 -2.83905 -368 2 16.7745 5.97673 0.482414 9.93705 -0.647346 -3.81794 -369 2 16.6178 7.22121 18.2734 18.8696 -9.84661 9.86066 -370 1 8.80495 6.92785 7.84504 -31.0915 -18.6038 9.28479 -371 2 9.6769 7.2872 7.80779 30.3288 7.87046 2.96903 -372 2 8.72406 6.35246 8.64105 6.6093 9.83872 -10.9319 -373 1 12.3211 0.614363 1.17365 13.0662 -3.77868 -0.487657 -374 2 13.0766 0.983141 1.64654 -0.239842 1.32967 3.5541 -375 2 12.751 18.5673 0.657414 -10.2946 0.778432 -2.83622 -376 1 5.67951 15.1028 14.5131 10.9467 16.6442 -3.65569 -377 2 4.71936 15.1727 14.6088 -3.18386 3.297 0.861488 -378 2 6.03308 15.9436 14.1233 -11.409 -15.106 9.73801 -379 1 3.83531 6.52602 1.68735 -5.34791 11.2881 1.09554 -380 2 3.46655 7.33088 1.27913 5.03876 -12.3281 -3.02901 -381 2 3.83759 6.80671 2.60341 5.67562 -6.55284 8.9174 -382 1 3.89065 11.6139 12.2421 9.17745 -10.34 -2.42323 -383 2 4.7546 12.041 12.3761 -4.43478 1.7756 4.32079 -384 2 3.22616 12.1252 12.7041 -4.55935 10.4369 8.15325 -385 1 5.44913 3.8771 15.872 6.89679 52.3696 13.3559 -386 2 6.00532 3.19945 15.5174 15.3476 -19.3003 -7.67953 -387 2 6.04432 4.69577 15.9682 -27.8341 -34.2187 -5.04159 -388 1 14.46 10.319 4.39654 9.99722 -28.3378 -34.0856 -389 2 14.8446 9.82936 5.13517 -3.65574 0.244774 4.37558 -390 2 14.7053 9.78242 3.56924 -11.9433 24.8074 33.8136 -391 1 7.944 17.2975 9.23787 -28.0002 30.4191 -3.50914 -392 2 7.19679 17.6006 9.79194 10.1387 -11.5361 -1.79961 -393 2 7.93806 17.9436 8.50883 9.12371 -8.84918 -0.989999 -394 1 4.50274 14.4265 3.96251 25.8442 16.5744 44.5421 -395 2 4.82189 15.3364 4.24204 -15.9069 -22.6382 -13.9696 -396 2 4.78076 13.8411 4.72747 -13.1976 12.376 -28.3375 -397 1 14.3227 7.38582 15.7589 14.6846 6.74467 9.8564 -398 2 15.2487 7.24382 15.4614 -20.8339 3.06086 7.28672 -399 2 14.432 7.78597 16.648 -5.3607 -7.66211 -14.83 -400 1 2.87305 18.2228 1.9038 16.9424 31.4889 37.3817 -401 2 2.5254 17.6641 1.24513 -20.0746 -27.9737 -30.7942 -402 2 2.12041 18.5329 2.44243 8.04928 -1.15784 -8.26421 -403 1 7.96513 1.6038 4.534 28.375 12.0389 1.8382 -404 2 7.4881 1.94169 3.78174 -16.4915 0.831655 -6.1583 -405 2 8.81315 2.08427 4.47067 -11.0504 -12.9149 7.37414 -406 1 2.66628 14.1304 17.7551 -36.5802 -20.3813 5.76686 -407 2 1.82799 13.6385 18.0009 26.1666 13.51 -7.41699 -408 2 3.38829 13.5766 18.1016 -3.21353 7.84202 -3.40779 -409 1 0.72398 1.68558 13.861 19.6061 1.62564 -3.20216 -410 2 0.832024 1.51571 14.7895 8.81281 -5.19825 13.648 -411 2 18.448 1.87896 13.7961 -22.7247 6.41229 -8.76432 -412 1 4.5528 18.6039 13.9643 16.282 -5.93943 -10.6264 -413 2 5.43228 18.1791 13.8337 -18.6035 11.3559 2.42201 -414 2 4.30609 18.3878 14.8696 -5.35687 -0.29015 4.72759 -415 1 7.10471 0.475722 18.3652 -9.95344 30.3778 33.8159 -416 2 7.09526 0.10374 17.5021 -2.11792 -9.18089 -28.9852 -417 2 6.24907 0.928295 18.5508 11.5399 -12.8337 -6.73806 -418 1 16.1003 18.4419 14.1295 -36.1288 -26.1963 -8.72431 -419 2 15.3858 17.8107 13.8537 25.0074 20.4613 -2.43664 -420 2 15.9155 18.5409 15.0697 10.6475 8.10349 1.05551 -421 1 10.1087 4.51964 16.2872 -49.6317 2.46368 -20.184 -422 2 10.9899 4.47274 16.5903 35.3659 -6.27505 9.52333 -423 2 9.84839 3.65208 15.9265 12.032 5.89647 9.33422 -424 1 15.84 17.9245 4.41355 -16.3771 8.07859 19.8211 -425 2 16.4973 18.6399 4.5293 -6.75294 -6.64677 -2.2152 -426 2 15.0245 18.216 4.92863 29.2279 -12.5546 -21.8691 -427 1 6.93052 17.3604 13.733 43.7573 11.6301 8.94285 -428 2 7.46287 17.7112 14.5144 -20.3873 -12.0805 -21.5216 -429 2 7.61723 17.2481 13.0216 -16.2109 2.19972 16.1164 -430 1 13.284 6.56612 6.73549 -17.3988 -10.9235 -13.9284 -431 2 14.2147 6.66272 6.66556 31.8926 9.42178 10.838 -432 2 13.0817 6.39483 5.81333 -16.4457 -2.73061 -4.18006 -433 1 7.68008 2.38704 9.18412 -10.173 -8.0052 -21.8631 -434 2 7.24249 2.31281 10.0234 -2.88588 -0.126179 20.3224 -435 2 6.98126 2.1061 8.54708 21.029 6.80491 7.05088 -436 1 15.1532 14.8723 13.6487 -17.4978 4.30428 5.82091 -437 2 15.0143 15.0659 14.5909 6.59258 -1.67926 -7.31154 -438 2 14.3234 15.1254 13.2077 14.4343 -4.04757 1.78875 -439 1 9.30028 8.33456 3.70705 10.2977 -8.98362 5.75949 -440 2 10.1463 8.82212 3.80538 -6.03443 -8.47657 3.00821 -441 2 9.47356 7.38745 3.89392 -0.00834887 14.0135 -2.32863 -442 1 17.6906 13.477 16.4461 19.9282 13.2905 -5.82842 -443 2 16.7369 13.3711 16.3792 -1.87427 5.41308 -4.03884 -444 2 17.9311 14.3351 16.016 -12.453 -14.9372 6.18952 -445 1 5.04349 10.6567 2.59903 16.1191 -13.6813 18.2195 -446 2 5.79495 10.2927 3.12129 -13.5181 3.52014 -12.0414 -447 2 4.57705 11.1773 3.24438 -8.0447 10.2459 5.04269 -448 1 3.70971 8.35842 10.3252 1.44092 -18.6834 3.58878 -449 2 3.85247 9.29033 10.1825 3.16815 17.7869 -8.4001 -450 2 3.85129 8.23256 11.2753 -2.11366 -0.888936 -6.9574 -451 1 16.1019 7.11228 6.32302 5.1556 -18.0856 -12.5793 -452 2 16.7603 7.67894 6.76117 -3.13697 -10.0137 -6.06994 -453 2 16.5199 6.22503 6.17941 -9.70023 19.4355 5.8489 -454 1 15.1873 7.00993 9.1119 -0.598311 32.9952 -33.7165 -455 2 16.0219 7.38603 9.44635 -11.3494 -6.74009 0.758637 -456 2 15.0255 7.54922 8.27157 3.37955 -23.1281 33.9738 -457 1 6.44391 13.1496 12.9059 -4.52757 0.45998 7.29234 -458 2 7.24313 12.6736 13.1625 -0.99472 -4.48021 -2.73775 -459 2 6.29798 13.7908 13.6311 -2.25413 -7.45453 -16.6836 -460 1 12.1229 4.49714 13.069 31.9377 20.6864 19.2416 -461 2 12.2438 4.59516 14.0263 7.18846 6.47209 -3.71556 -462 2 11.355 3.98337 13.0276 -40.2556 -25.9573 -14.351 -463 1 11.341 8.18871 7.85243 -8.78275 4.89867 3.16356 -464 2 12.019 7.65272 7.40248 3.56578 3.50389 11.6767 -465 2 11.6495 8.4222 8.75253 4.0122 -9.00416 -11.7002 -466 1 17.1801 10.777 7.4192 7.36201 -8.80257 6.42916 -467 2 17.8272 10.0453 7.20283 -14.4353 25.3005 -3.23105 -468 2 17.1099 11.4706 6.73084 6.53972 -12.3853 -1.04707 -469 1 5.23123 18.1422 11.0533 -19.2518 -11.1169 -0.556795 -470 2 4.68428 18.0818 11.8689 9.03658 -0.237539 -15.4649 -471 2 4.66385 17.8138 10.3113 13.0077 11.3369 14.9543 -472 1 7.56693 17.6215 1.82415 1.62007 -3.46367 5.28784 -473 2 7.78898 16.8334 1.34681 6.63524 -26.0188 -1.32905 -474 2 7.45125 18.2129 1.09256 -3.64481 20.3372 -5.96154 -475 1 1.86389 12.9287 13.6093 11.2123 10.389 11.461 -476 2 1.60858 12.3493 14.3514 0.368407 5.87334 -8.62616 -477 2 2.19533 13.7617 14.0254 -8.04715 -19.4049 -4.74077 -478 1 9.73211 6.79545 14.8053 -13.3635 29.1677 -1.2594 -479 2 9.95388 5.9401 15.1198 6.74212 -35.5267 16.6171 -480 2 9.99758 6.80472 13.8879 2.87601 5.55808 -10.3757 -481 1 15.2079 4.3816 10.7747 2.87683 -10.6846 -6.34453 -482 2 16.1141 4.09829 10.8354 14.0041 -14.4682 -8.99775 -483 2 15.2413 5.10857 11.3759 -13.982 19.572 13.657 -484 1 11.1943 6.12299 0.161942 7.30858 3.38886 3.78771 -485 2 11.3169 5.17116 0.363074 -11.79 12.5462 -9.55941 -486 2 10.2709 6.35961 18.5708 8.1781 -12.6509 6.67443 -487 1 0.185288 11.3311 15.1365 -30.887 25.32 -22.6423 -488 2 18.3259 11.8316 14.411 15.9364 -20.9841 19.9458 -489 2 18.5436 11.8171 15.9275 6.31494 -1.3813 -2.75882 -490 1 7.07253 9.14554 7.26503 -12.8693 -9.44748 7.54332 -491 2 6.53496 8.39024 7.60511 8.01051 18.2562 -7.56901 -492 2 7.96025 8.78683 7.22728 5.66006 -0.214789 -0.295522 -493 1 18.4466 15.4455 12.3524 0.715601 -5.5542 4.25712 -494 2 0.765537 15.5739 12.2932 -9.35503 -1.07101 -3.81958 -495 2 18.1041 15.6865 11.4834 1.82716 1.84183 -0.0676895 -496 1 16.5728 4.36435 5.2485 -25.4993 -8.29978 29.4912 -497 2 16.6816 3.92322 6.14286 5.98391 16.1522 -30.7717 -498 2 17.375 4.39451 4.72672 17.8313 -3.46111 1.89189 -499 1 17.7791 3.0704 10.7152 16.7916 7.15275 7.98838 -500 2 0.0816242 3.14072 10.966 -13.8603 5.05813 -1.71981 -501 2 17.7027 2.20602 10.3066 -7.17166 -8.4112 -5.21368 -502 1 12.3075 0.0618611 10.1685 -8.15907 17.9474 -0.312818 -503 2 11.3684 0.344551 10.3468 27.9971 -1.27027 -0.956139 -504 2 12.8942 0.865557 10.2681 -22.4015 -23.39 -3.54403 -505 1 10.3613 9.82386 12.3172 12.1455 12.129 19.7304 -506 2 11.1427 9.8808 12.9129 -10.2174 -2.53791 -7.09814 -507 2 10.1997 8.88396 12.252 -0.966331 -12.4705 -0.927319 -508 1 0.481536 2.83002 7.02126 3.70324 23.8076 -10.0458 -509 2 0.770856 3.62826 7.51109 -3.83076 -19.2444 -0.666321 -510 2 0.694466 2.06428 7.55035 5.7415 -3.83046 10.8422 -511 1 0.467049 15.2425 6.91705 -4.45928 -38.0226 -11.2702 -512 2 0.600151 15.6263 7.78281 2.30728 -6.41275 13.0317 -513 2 0.61271 14.2361 7.00049 -2.84554 47.7716 -5.16909 -514 1 16.9541 7.01237 15.3291 23.6374 -7.48971 -3.1828 -515 2 17.7457 7.53254 15.1705 -1.99719 18.034 -6.10418 -516 2 17.38 6.19105 15.5941 -13.3003 -10.4743 0.120416 -517 1 9.01017 12.4224 8.1441 -46.2717 9.6088 -11.1501 -518 2 9.26268 11.8248 7.45061 25.2615 -14.9445 -10.6927 -519 2 8.05034 12.5239 7.91838 26.5695 6.53823 20.3475 -520 1 1.26455 1.94093 3.05316 3.58571 9.71968 -12.011 -521 2 1.22461 2.59742 2.34045 -8.12686 -11.986 1.71554 -522 2 1.93366 2.31359 3.63129 0.35358 -2.72116 4.87465 -523 1 4.13309 15.1146 9.63821 -4.623 1.46382 -0.938733 -524 2 4.12694 15.148 8.67475 -7.89004 5.45838 -0.100118 -525 2 4.98588 14.7259 9.81048 11.3537 -4.87926 10.963 -526 1 7.17766 2.17952 14.5652 7.62536 9.73749 11.0593 -527 2 6.96972 1.69872 13.7643 -0.327528 -0.451328 -7.35604 -528 2 7.66158 2.98182 14.3072 -3.86315 -8.18785 -0.50787 -529 1 18.6094 14.7115 2.1553 18.1066 -29.4746 -3.14947 -530 2 0.852094 15.108 2.23259 -6.38197 3.09186 -0.259441 -531 2 17.9366 15.3527 2.32074 -15.2526 23.2774 3.26778 -532 1 9.94663 2.7868 12.9455 2.69617 -13.1789 -11.1834 -533 2 9.77369 2.19316 12.1903 7.43131 1.21406 6.14773 -534 2 9.20096 3.38667 12.9408 -6.30409 9.38042 4.37845 -535 1 2.80852 8.91644 13.0153 -16.8956 -9.28674 -0.0207487 -536 2 3.13809 9.78934 12.8448 9.36486 20.7895 -4.33486 -537 2 3.52774 8.43066 13.407 13.2058 -10.3846 6.75792 -538 1 3.23128 8.35577 3.63883 6.10249 8.71431 60.2633 -539 2 3.54401 9.08838 3.13137 7.96401 15.5303 -21.3649 -540 2 3.46232 8.64756 4.58519 -13.4978 -19.9669 -35.5279 -541 1 5.63324 7.19832 8.5125 -13.133 -10.0414 6.96154 -542 2 5.51092 6.25688 8.34615 12.8941 -5.44374 -4.51219 -543 2 4.92213 7.36133 9.14092 2.83191 13.4678 4.26874 -544 1 14.878 1.27944 2.0109 -7.35803 -30.2596 -13.1701 -545 2 14.8616 1.98275 2.64555 4.54601 24.3613 2.83628 -546 2 15.264 1.50064 1.14913 0.22226 12.7122 6.62367 -547 1 8.2353 15.1956 0.84899 9.2054 13.6294 -15.3468 -548 2 9.04355 15.0937 1.38227 -7.5254 -5.87742 4.76726 -549 2 7.50355 14.6763 1.20804 4.58246 -4.32042 7.88142 -550 1 15.6328 1.34461 7.23795 -19.9173 -11.1245 -9.46976 -551 2 14.9591 0.718796 6.85982 16.5955 19.1651 8.9454 -552 2 15.1508 2.16575 7.45752 1.02199 -7.71962 -3.30529 -553 1 4.91374 13.0908 18.526 15.2565 -4.60213 14.3208 -554 2 5.33439 13.1154 0.77269 -6.07604 1.59812 -16.6926 -555 2 5.51105 13.5936 17.9543 2.83588 -2.74206 0.160853 -556 1 15.3493 8.4742 18.1502 12.1518 9.73195 -18.1744 -557 2 15.7592 9.1135 17.5088 -10.0207 -13.011 16.7995 -558 2 15.2243 8.95162 0.336167 -0.033387 6.18709 -0.40176 -559 1 12.0721 3.03363 18.372 7.89134 -10.3745 2.1206 -560 2 12.0185 2.56449 0.551271 -8.88822 8.03447 17.3967 -561 2 12.5632 2.36483 17.898 4.02516 4.57474 -24.0136 -562 1 13.2076 12.6757 5.17908 4.47921 -5.37266 1.03993 -563 2 13.7293 11.9632 4.79272 -2.12471 -1.88137 -7.76598 -564 2 13.3867 12.5644 6.11349 -3.52883 8.17381 9.78336 -565 1 6.04737 7.04753 0.0353989 10.049 -23.447 -5.31085 -566 2 6.01346 7.99319 18.6275 -7.37118 27.2698 7.20756 -567 2 5.32085 6.74358 0.593628 -6.10646 3.40609 1.47388 -568 1 17.7373 16.0235 15.0083 12.9173 -11.5355 46.7271 -569 2 16.9426 16.5159 15.2406 -3.68569 -0.0523083 -17.9381 -570 2 17.9142 15.8937 14.0864 -12.7219 4.58342 -31.2732 -571 1 13.1912 1.0014 16.5506 10.6966 -14.1722 10.2872 -572 2 14.1553 0.911674 16.6931 -11.9901 3.10273 -3.01829 -573 2 12.8874 0.074803 16.5753 -2.30324 8.04411 -4.14072 -574 1 11.1133 14.5665 7.20897 13.0955 23.3619 -16.6223 -575 2 10.3963 14.2935 7.74934 -21.4591 -15.3449 18.7975 -576 2 11.8402 13.9563 7.34501 4.8973 -5.05394 6.63835 -577 1 17.5096 8.63113 2.08657 0.966478 12.3426 12.6691 -578 2 16.6632 8.50317 2.50987 -10.5053 2.55961 10.3047 -579 2 17.5113 7.91267 1.47949 7.23292 -21.4893 -25.4513 -580 1 12.353 7.99884 2.01581 -2.70101 10.6364 -12.6504 -581 2 12.1945 8.88312 1.63494 1.68617 -6.44935 12.5501 -582 2 11.9639 7.41552 1.35659 -1.58766 -9.18843 -2.08326 -583 1 11.8879 14.6194 10.3406 -20.0746 -33.6598 -22.8547 -584 2 12.0361 13.784 9.8263 4.17148 28.2224 18.5196 -585 2 10.9018 14.6878 10.3309 21.6541 8.7111 3.83339 -586 1 6.88836 7.04362 15.6058 16.1194 20.5136 16.4981 -587 2 7.8035 7.27617 15.3369 -14.4637 -10.2261 -3.41305 -588 2 6.75267 7.59066 16.4113 -4.12685 -13.7627 -18.0291 -589 1 8.00073 4.72844 13.473 32.6072 13.4681 12.0072 -590 2 7.24466 4.78195 12.9199 -26.1194 -0.34176 -19.7698 -591 2 8.43099 5.60279 13.3668 -6.56701 -17.694 4.3215 -592 1 13.409 12.181 14.2619 -2.29334 -12.519 -3.59046 -593 2 13.0674 11.2691 14.1939 2.47622 3.528 5.79283 -594 2 13.8091 12.3245 13.3914 2.14013 7.29019 1.49174 -595 1 14.8335 9.42126 7.30208 -1.23415 -9.7028 -7.755 -596 2 15.6553 9.87909 7.43544 15.0677 5.06613 0.278043 -597 2 14.1895 10.0298 7.62302 -19.0881 6.3544 7.09879 -598 1 12.6523 17.0615 3.07749 -9.63712 20.8437 4.73829 -599 2 12.9489 17.4748 3.92954 -9.59054 -7.90452 -22.4084 -600 2 12.0211 17.6908 2.6147 24.5964 -20.1603 22.3384 -601 1 1.16316 7.14216 17.4575 -7.53687 9.98877 -12.7143 -602 2 0.304551 7.18474 17.9202 3.89796 -5.88799 -6.19513 -603 2 1.03245 7.53978 16.5617 1.30151 -5.77621 16.2427 -604 1 12.7701 5.15004 15.6505 19.6392 -10.8067 9.95473 -605 2 13.4563 4.50157 15.9538 -13.2351 19.2956 -11.0391 -606 2 13.2014 6.03319 15.6187 -0.0564141 -13.897 1.41482 -607 1 2.5292 3.39223 4.98971 -11.294 24.8894 43.5462 -608 2 1.79321 3.13497 5.63732 25.431 9.26734 -19.6171 -609 2 2.95221 4.24201 5.36402 -18.0427 -37.3772 -14.0443 -610 1 8.3195 11.2975 13.4498 34.4282 -42.0873 60.0692 -611 2 8.53145 10.9623 14.3727 -32.5783 27.093 -24.5589 -612 2 9.06913 10.8398 13.0623 -1.46455 6.72769 -32.5395 -613 1 12.8789 1.33599 13.3369 -0.326833 21.0111 -2.4484 -614 2 13.4114 1.42549 12.5087 -12.3149 4.19021 14.3531 -615 2 12.3728 2.16885 13.5095 17.1543 -18.8215 -15.124 -616 1 6.3438 13.6989 2.14861 -9.76603 2.4566 0.239062 -617 2 5.66699 13.9965 2.80165 17.5467 -9.19207 -8.6938 -618 2 6.94024 13.0708 2.57673 -0.273551 -0.649347 7.27334 -619 1 15.9211 6.60722 12.7931 -16.6599 -18.553 -4.38331 -620 2 16.3967 7.19214 12.2261 12.0088 12.5524 -15.4249 -621 2 16.3823 6.6241 13.6257 5.92705 1.19016 14.7721 -622 1 16.8355 0.712467 9.59592 -3.36362 -23.3789 -3.56206 -623 2 16.7779 18.376 9.75078 1.74957 20.9638 -0.413143 -624 2 16.4581 0.840534 8.70411 1.17104 2.38037 5.50581 -625 1 6.14488 11.7511 8.38011 -0.18946 -41.167 -3.37934 -626 2 5.27459 11.5011 8.78729 18.3987 2.85732 -10.3128 -627 2 6.60987 10.8879 8.11154 -22.1828 30.5528 10.1053 -628 1 2.89693 8.62105 0.44295 -56.4203 1.00956 -31.5069 -629 2 2.27197 8.22062 18.4324 34.822 -7.67477 5.45833 -630 2 2.23776 9.23156 0.789096 17.398 15.3469 20.296 -631 1 10.1637 10.4615 6.50349 -4.04384 3.34709 -8.13679 -632 2 10.5967 9.72069 6.94847 1.64295 -0.870339 0.249421 -633 2 10.4974 10.4621 5.5852 -1.057 -0.999308 12.8758 -634 1 6.73224 15.6973 6.55436 -2.09809 -5.48823 4.73835 -635 2 7.11043 16.1412 7.33204 2.41282 1.16671 -8.98558 -636 2 7.01002 16.1566 5.74315 2.18916 7.51026 7.17736 -637 1 6.44608 13.1679 5.58195 -4.20705 -14.9444 9.79279 -638 2 6.65412 13.9682 6.06813 3.08652 7.67851 0.170606 -639 2 6.07667 12.5708 6.24938 0.761343 1.39557 -4.00611 -640 1 16.8208 12.5604 9.84104 -2.42329 -13.6856 -22.0974 -641 2 16.9708 11.9197 9.11347 0.32984 0.887075 14.5477 -642 2 16.637 13.3652 9.35916 0.987515 11.3295 4.43609 -643 1 6.04174 2.95051 2.84722 -0.719082 -29.0389 17.5165 -644 2 6.39757 3.79665 2.63265 6.28437 26.7212 -14.5644 -645 2 5.5959 2.56013 2.08759 -0.264068 2.45464 -11.4985 -646 1 10.912 3.32579 3.30021 -11.54 -3.72468 -0.286686 -647 2 10.265 3.99241 3.57025 6.99069 0.708994 3.18227 -648 2 10.4899 2.90229 2.54711 3.22659 -3.75767 -5.68185 -ITEM: TIMESTEP -20 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.70913 7.06604 17.9499 1.08039 -7.3052 -10.6944 -2 2 7.76309 6.93671 18.0927 2.86377 -0.0634365 6.14939 -3 2 8.89082 6.62218 17.113 -0.435012 1.17195 3.96762 -4 1 18.5701 8.27154 6.84569 7.63886 -4.25596 16.0618 -5 2 0.0770478 8.01704 5.94511 2.80666 -2.10014 -27.175 -6 2 0.448594 7.6266 7.34851 -2.05713 5.96795 6.45131 -7 1 8.39922 18.5714 6.82203 6.72948 10.2859 -1.45868 -8 2 9.32775 0.155905 6.65662 -6.00666 -1.87083 0.283604 -9 2 7.88802 0.6421 6.41318 2.19693 -3.22314 0.641978 -10 1 6.59462 1.83749 11.6886 4.57701 1.91935 4.50468 -11 2 5.92153 2.26167 12.2253 -5.29818 6.79114 -2.36061 -12 2 6.2022 0.990271 11.4833 -4.39091 -13.1588 -5.35683 -13 1 7.12455 5.7334 2.35273 -30.6289 32.8622 11.4294 -14 2 6.61502 6.28908 3.00258 14.1285 -25.9969 -7.59408 -15 2 6.93422 6.24286 1.54682 10.1555 -14.3812 -3.81516 -16 1 16.2065 10.1646 16.1262 8.40668 11.1152 -6.07805 -17 2 17.0895 10.2474 15.7446 -2.7739 -5.15617 3.84543 -18 2 15.9438 11.0841 16.2665 -7.12418 -3.1551 3.11568 -19 1 10.6155 14.9936 2.32061 -1.92123 -0.42827 -4.10202 -20 2 10.587 14.5409 3.17342 -1.90113 -4.17135 2.45193 -21 2 11.1106 15.7965 2.49753 3.42935 4.58062 3.08668 -22 1 17.1538 8.25609 10.4362 5.05968 0.945942 4.2849 -23 2 16.7065 8.97876 10.9029 -1.41924 -5.56537 3.25582 -24 2 18.0123 8.61559 10.168 -2.45464 0.72557 0.389593 -25 1 14.8661 15.8683 16.3562 3.75833 -10.1031 -0.407994 -26 2 13.9609 16.1531 16.2809 -17.2441 8.84265 -1.93831 -27 2 14.8525 15.2671 17.1114 5.79928 3.60638 8.20478 -28 1 12.159 13.3907 0.439783 -6.21112 9.36015 -5.49833 -29 2 12.0312 13.5738 18.1447 5.07318 -6.56614 -2.93527 -30 2 11.6434 14.08 0.875998 -3.18612 -5.19303 11.2101 -31 1 9.2695 5.40921 4.0396 -15.9764 -20.2303 6.13461 -32 2 8.8083 5.02157 4.82949 8.30048 18.0685 -17.5094 -33 2 8.61456 5.30675 3.30783 11.5288 9.4755 11.0493 -34 1 1.82939 4.25621 11.6493 -6.71206 2.38393 -0.709376 -35 2 1.74358 5.20905 11.8686 0.595776 -11.527 -1.23597 -36 2 2.30823 3.82152 12.3665 0.967745 0.8605 0.134832 -37 1 1.98223 6.83069 8.36497 -5.35455 0.0641687 -19.1444 -38 2 2.41924 7.2303 9.11786 5.68758 -2.51321 7.89524 -39 2 2.03012 5.87061 8.47368 0.241822 -0.370612 9.81388 -40 1 5.39801 4.40718 7.93771 10.9733 2.82986 12.12 -41 2 5.47637 3.44759 8.05616 -6.09239 2.90192 -10.948 -42 2 4.7514 4.61131 7.25273 -1.49389 -3.85519 0.176314 -43 1 3.26825 2.92232 17.539 -14.9988 14.8633 6.4114 -44 2 3.91862 3.43305 17.0175 -2.74895 -4.28964 2.11315 -45 2 2.69145 3.57031 18.023 20.6758 -7.505 -11.8237 -46 1 7.47034 5.2735 6.10589 -2.49502 5.37071 -3.04547 -47 2 7.84271 5.98269 6.68437 -5.78386 -20.7203 -0.884416 -48 2 6.94663 4.6123 6.60405 7.6241 17.9385 5.03136 -49 1 9.77266 7.01281 11.9821 10.4665 -1.38292 10.7277 -50 2 10.3585 6.42202 11.517 6.59042 -6.6592 -2.49871 -51 2 9.12807 7.25863 11.3259 -16.7919 6.8996 -8.63143 -52 1 14.096 3.56038 8.06303 -5.03459 -1.11151 -11.1946 -53 2 13.7156 4.24767 7.5046 0.899669 0.845681 1.92473 -54 2 14.4812 4.01512 8.80943 2.7486 3.89851 9.64387 -55 1 4.73966 17.2567 4.00996 -0.195125 14.326 -18.5317 -56 2 5.55163 17.7707 4.1353 -4.1295 -8.09403 5.71009 -57 2 4.38972 17.5915 3.15482 -7.00181 -7.87351 15.3992 -58 1 16.5025 16.6092 10.0733 13.1432 9.20378 8.07617 -59 2 15.9712 16.6856 10.8668 -9.96451 -5.5735 1.54085 -60 2 15.9848 16.1464 9.41138 -7.70063 -5.20479 -0.44901 -61 1 1.97052 4.91045 0.450899 1.06366 9.69844 4.9192 -62 2 2.61093 5.33981 1.06219 -5.49885 -10.5105 -8.09306 -63 2 1.57388 5.6737 18.6422 7.70456 -7.85061 -0.972244 -64 1 11.7662 13.3441 16.2815 -7.88535 5.38496 10.7421 -65 2 11.2704 12.5109 16.442 6.50023 4.10664 -10.6094 -66 2 12.3479 13.2575 15.5066 -9.92493 -12.14 1.82083 -67 1 10.1201 11.0576 16.9389 3.39974 -19.6625 0.923124 -68 2 10.5319 10.1651 17.0061 -5.17122 15.3709 -2.15755 -69 2 9.17725 10.8754 16.8052 5.13113 2.71984 -2.06215 -70 1 11.7111 17.5152 13.4588 11.325 -2.75861 -1.19784 -71 2 12.3718 17.1152 12.8813 -0.632983 -4.36671 1.26506 -72 2 11.9961 18.4406 13.4806 -4.40298 2.90056 2.38202 -73 1 6.35795 9.30394 12.2283 8.95317 6.42027 -9.35456 -74 2 6.91663 9.09838 11.465 -5.59359 -11.5346 -0.139091 -75 2 6.8458 10.0391 12.6013 -0.320164 5.49925 11.3434 -76 1 16.2195 12.7457 2.69542 0.295574 -29.3957 1.13627 -77 2 17.0216 13.1501 2.38091 9.97003 13.3951 -1.47132 -78 2 15.5842 13.4209 2.91145 -9.8096 20.1499 -2.69183 -79 1 0.634077 12.5728 5.88372 -7.9484 2.86768 -4.89493 -80 2 0.988616 12.3569 5.00851 -6.1101 5.76055 1.83916 -81 2 18.334 12.7959 5.71409 15.811 -6.64636 4.43625 -82 1 5.2077 16.407 18.4749 -9.68849 -0.552221 -6.28119 -83 2 5.84718 15.7794 18.0984 2.41425 5.32286 5.94338 -84 2 5.56586 16.8292 0.618687 8.26881 -4.78153 -1.34873 -85 1 0.531249 7.63213 4.08542 33.6963 23.9515 -16.2824 -86 2 18.6021 7.94352 3.35108 5.75308 0.311196 11.7347 -87 2 1.44781 8.03396 3.8909 -38.1012 -20.2476 4.98268 -88 1 3.13519 8.90219 6.5128 -18.1806 -1.10975 19.7922 -89 2 3.61721 8.66647 7.3217 -0.167991 0.711605 -10.7948 -90 2 2.18954 8.88363 6.78472 17.5501 0.713198 -9.35234 -91 1 7.30642 10.3086 16.1993 0.33826 1.86993 11.5423 -92 2 6.5825 10.5097 15.5962 -1.40069 -1.74837 7.12047 -93 2 6.94436 10.2588 17.1142 -3.68695 0.804433 -15.344 -94 1 11.1033 1.05136 4.99998 6.51415 -6.68887 15.4104 -95 2 11.3804 1.86173 4.55399 -8.93638 -1.72916 -9.27788 -96 2 10.7652 0.40817 4.35737 0.804793 8.53975 -5.36269 -97 1 4.41906 2.71829 13.1993 1.75265 -17.8891 31.6776 -98 2 4.61925 3.15892 14.0364 2.0928 12.2335 -7.50334 -99 2 4.34595 1.79439 13.5397 -3.31279 7.49147 -22.0731 -100 1 8.39429 10.0534 1.8011 7.989 6.96853 5.58503 -101 2 8.43083 10.7556 2.48299 -4.47719 -6.35615 -3.34103 -102 2 8.76263 9.25633 2.22388 -6.49712 6.95404 -2.63041 -103 1 10.5097 1.74962 15.5619 -18.3761 -0.922722 7.55335 -104 2 11.4225 1.47346 15.6803 4.80494 4.8298 -6.32182 -105 2 10.3374 2.00269 14.6445 6.81104 -1.01801 -3.49857 -106 1 2.7507 12.9226 7.76103 -0.99391 -3.54814 -5.35437 -107 2 3.2837 13.6196 7.35675 1.026 0.47841 4.16479 -108 2 2.1823 12.6261 7.03948 -5.64928 1.37633 4.69044 -109 1 3.65655 11.6901 5.29539 -1.74666 1.04695 -5.47464 -110 2 3.42979 10.9863 5.91968 -0.390133 2.11749 -7.53732 -111 2 2.90341 11.8434 4.69867 6.59799 -3.91283 3.78854 -112 1 6.86195 14.4839 16.8677 -6.59977 -5.37582 9.26387 -113 2 7.63594 13.9204 16.7929 -0.0312736 1.63672 -3.94334 -114 2 6.43125 14.5303 16.0039 6.73415 3.59122 -3.18668 -115 1 14.1795 14.5536 3.39757 15.4782 -5.44823 -10.5 -116 2 13.7027 15.3725 3.25557 -8.02005 3.41109 -0.200737 -117 2 13.6761 13.9828 3.97966 -5.46722 0.130817 9.75683 -118 1 8.30625 18.1704 16.0558 -18.3501 -5.93921 0.16691 -119 2 8.73243 17.3486 16.3757 13.662 16.7968 -4.53324 -120 2 8.86048 0.311637 15.8745 11.2379 -14.2941 4.19403 -121 1 4.7262 1.6175 4.92485 1.6266 19.4211 -17.3379 -122 2 3.85517 2.05812 4.84475 13.0303 -7.24689 7.72044 -123 2 5.31448 2.15314 4.34837 -14.7695 -11.1634 6.67198 -124 1 15.0789 12.7964 16.4332 -6.30353 8.33681 17.3183 -125 2 14.5699 13.1854 17.1557 10.6035 -4.81202 8.18161 -126 2 14.431 12.7912 15.7403 -5.45963 -10.7064 -24.7799 -127 1 15.7876 18.4014 16.8102 7.97993 -1.6905 34.0366 -128 2 16.3475 18.509 17.631 -13.1355 2.97046 -27.3317 -129 2 15.4303 17.5059 16.9211 5.07282 4.66478 -9.26997 -130 1 1.15379 1.15776 16.5585 8.66192 -1.89028 -5.04545 -131 2 1.90132 1.75074 16.7615 -7.4852 -3.92147 5.78546 -132 2 0.484053 1.2881 17.242 6.61018 5.41271 -0.381602 -133 1 18.0958 4.56873 15.8951 8.25715 -8.22974 -2.59939 -134 2 18.5403 4.03662 15.2192 -4.31028 2.25805 3.56674 -135 2 18.6753 4.5681 16.6654 -3.11748 0.528024 -3.18079 -136 1 12.2229 16.9717 16.1366 4.99185 -14.9968 15.1993 -137 2 11.5697 16.3784 16.5746 6.13992 18.0067 -10.7689 -138 2 12.0903 16.9196 15.1862 -11.661 1.79059 -6.40221 -139 1 15.9175 2.52925 17.9868 -5.04918 24.4496 -1.91719 -140 2 15.7053 3.35036 18.4645 1.43445 -9.55155 0.206063 -141 2 15.6037 2.74854 17.0829 8.19816 -13.208 8.21894 -142 1 6.7035 13.812 10.2396 3.19471 14.7437 0.534165 -143 2 6.61208 13.6203 11.1841 -1.85117 -10.3739 -2.65392 -144 2 6.65674 12.9942 9.7292 -2.15383 -4.24588 3.01674 -145 1 10.13 18.2471 2.79005 6.2323 7.4499 -7.90816 -146 2 10.2641 0.289717 2.1086 -4.88175 -4.44055 6.63338 -147 2 9.27512 17.8471 2.59242 -0.00557908 4.28296 0.85488 -148 1 2.97726 17.7544 6.09154 9.3411 -8.798 -12.7807 -149 2 2.21419 17.6669 5.51339 -17.57 2.09099 8.77855 -150 2 3.67394 17.6484 5.43984 9.00485 8.25893 -0.00709571 -151 1 12.565 16.9537 7.99058 7.14198 1.79921 -4.31208 -152 2 11.8238 16.3251 7.88339 1.67036 10.005 4.65414 -153 2 12.3624 17.6704 8.62526 -6.57036 -14.6618 3.16709 -154 1 14.8823 15.2807 8.26789 -1.91265 -14.526 28.7428 -155 2 14.153 15.9118 8.23916 -2.47753 6.09246 -10.9919 -156 2 15.4304 15.3156 7.48892 0.613021 10.1448 -23.5664 -157 1 17.5919 18.2849 0.376053 -34.2379 -2.64943 -3.08159 -158 2 18.3697 17.8673 0.0312256 25.6277 -7.0964 -1.13253 -159 2 17.798 0.454484 0.829223 12.3697 7.05842 3.85092 -160 1 0.890355 10.3869 1.40531 11.5261 -26.8893 18.421 -161 2 0.106732 9.81739 1.52594 3.68606 12.403 0.666184 -162 2 0.670163 11.0869 0.811123 -14.943 21.2909 -16.3167 -163 1 1.59243 12.2061 3.32787 10.8868 -1.98125 32.4665 -164 2 1.41581 11.4302 2.79423 -4.35317 -0.696655 -17.6875 -165 2 1.68603 12.9921 2.7891 -2.29445 2.46974 -13.9165 -166 1 0.556424 17.2525 4.88159 28.516 -3.31441 -27.2608 -167 2 -0.112492 17.9263 4.93691 -11.7284 7.93843 13.1539 -168 2 0.513874 16.5834 5.55808 -11.2757 -6.6263 16.6148 -169 1 1.11617 0.979823 9.41029 -8.01472 5.90786 -6.49609 -170 2 1.17088 0.754182 10.3385 12.3333 -8.44182 10.8127 -171 2 0.193916 0.78552 9.22994 -1.98368 -3.92324 -6.63209 -172 1 16.7786 2.33534 13.2836 0.301257 -1.02782 -8.61363 -173 2 16.9098 2.55877 12.34 -0.551981 -1.96326 12.3514 -174 2 16.5533 1.39033 13.3371 -1.81134 4.54396 -2.66642 -175 1 2.50838 15.8231 12.1881 11.0759 -0.61625 -4.91684 -176 2 3.05623 15.4799 12.9137 -5.11001 1.87196 -7.11666 -177 2 2.97562 15.6336 11.349 -1.75425 -0.738878 7.05871 -178 1 16.4241 15.5762 5.95419 20.8818 34.7414 3.73321 -179 2 17.3417 15.6388 6.29893 -10.1511 -9.39035 -1.02331 -180 2 16.3256 16.4387 5.46724 -6.92566 -23.7939 4.29358 -181 1 5.82318 5.04015 11.787 7.38202 -1.28642 -1.97288 -182 2 5.53279 5.76584 12.3478 -8.19426 6.74642 1.34004 -183 2 5.25308 4.28957 11.9879 -3.19521 -0.0404241 -0.10221 -184 1 15.2058 4.86095 0.714988 -15.0911 -0.578133 32.6943 -185 2 15.0554 4.65905 1.68214 1.80466 1.09263 -27.7183 -186 2 14.3514 5.22673 19.0716 10.184 -3.76227 -2.57358 -187 1 16.3414 16.3313 2.1188 1.69452 -20.4231 -15.1031 -188 2 15.9696 16.7397 2.89766 0.772445 11.9995 9.83785 -189 2 16.487 17.0139 1.46036 1.64169 8.90638 2.00624 -190 1 0.27953 4.87193 3.80304 22.0083 21.7264 1.42732 -191 2 0.488965 5.84197 3.75834 -13.581 -23.7134 5.51739 -192 2 1.12962 4.47493 4.05501 -10.8528 -1.93786 -0.672788 -193 1 2.93644 15.0118 15.0505 -0.31189 -6.67479 38.4938 -194 2 2.77152 14.5973 15.941 9.17422 6.49202 -18.5047 -195 2 2.6087 15.9081 15.2082 -8.55577 3.59906 -10.383 -196 1 1.11893 14.5977 9.54871 15.5404 -15.1461 3.70851 -197 2 2.05973 14.499 9.39244 4.56619 15.8955 -5.72674 -198 2 0.980037 13.7309 9.94382 -18.1835 3.0763 3.0761 -199 1 13.6623 16.6444 11.5318 -24.61 2.13122 1.95847 -200 2 13.1623 17.4223 11.2076 12.7863 -8.68657 -5.97173 -201 2 13.1098 15.8918 11.2458 9.29846 2.29742 -4.43006 -202 1 4.71401 1.48013 0.724257 -0.188744 -1.90188 8.47653 -203 2 4.10877 2.04213 0.209428 1.54459 -7.39683 1.44825 -204 2 4.1847 0.878426 1.28084 -4.13807 4.124 -10.8706 -205 1 1.4317 18.499 11.8861 -0.747589 2.74228 -9.05649 -206 2 1.26248 0.376362 12.6752 -1.22453 3.10674 7.57799 -207 2 1.76508 17.6414 12.1696 1.67944 -1.01146 1.59049 -208 1 11.5426 10.114 4.08871 14.5973 5.39555 -25.8673 -209 2 11.3947 10.5181 3.18641 4.0612 -8.18021 22.6028 -210 2 12.5241 10.0302 4.19261 -20.6338 4.9276 -1.52234 -211 1 8.35442 12.1679 3.75067 -15.8416 -4.27069 -7.38356 -212 2 9.18656 12.6319 3.95442 -10.6107 -0.215004 12.2135 -213 2 7.67679 12.3128 4.45645 22.0699 3.83678 -6.48541 -214 1 14.3334 4.02625 3.28975 21.4077 6.9275 8.44763 -215 2 15.0849 4.22802 3.89908 -16.2072 -5.96795 -3.3621 -216 2 13.5509 4.49592 3.62574 4.82101 -0.669553 -3.42678 -217 1 5.57933 1.73516 7.50739 -24.0378 -31.7376 11.0088 -218 2 4.91074 1.07012 7.91595 32.7583 31.1537 -18.2093 -219 2 5.45045 1.65908 6.53973 -4.97377 0.997246 11.1506 -220 1 17.8945 1.1186 4.8831 -1.36037 -2.43827 -6.93143 -221 2 18.5804 1.42855 4.26031 -6.60553 2.78724 7.64102 -222 2 17.8025 1.76232 5.59874 4.87877 0.216211 -3.29328 -223 1 6.83024 9.40422 4.48506 -14.9488 0.581331 -12.2421 -224 2 6.75886 9.5424 5.43046 9.61942 2.86103 10.3107 -225 2 7.75214 9.21615 4.27366 4.86133 -4.03573 4.34319 -226 1 2.68867 14.9529 1.96243 -3.68441 -0.0776758 1.15821 -227 2 3.24659 14.6776 2.70632 3.58292 1.9147 -7.42106 -228 2 3.21497 14.9558 1.15083 1.81588 -2.88288 8.16929 -229 1 17.2949 12.8929 13.1574 -7.5849 14.4302 -4.04848 -230 2 16.4401 13.3055 13.2858 -13.783 -13.5119 9.83474 -231 2 17.7157 13.6748 12.8001 24.9453 0.592093 -1.55303 -232 1 15.0095 10.5719 1.38917 -11.2702 -15.2105 -5.46509 -233 2 15.5687 11.2426 1.76309 11.9887 12.322 8.95719 -234 2 14.2298 11.0424 1.10476 -6.47688 3.25886 -0.810136 -235 1 5.70264 6.91192 4.53101 4.96234 -7.94583 8.40724 -236 2 5.98573 7.83684 4.52277 1.36545 -0.678753 -1.4492 -237 2 6.33051 6.43499 5.10591 -2.47306 1.6182 -5.79546 -238 1 8.0801 8.26782 10.1943 -2.48094 -3.5573 30.8197 -239 2 8.76371 8.85191 9.85613 0.308879 9.43682 -13.0265 -240 2 7.56027 7.88877 9.48994 -2.62488 -0.283604 -15.3664 -241 1 13.5 18.3149 5.7974 -5.02979 10.2931 3.81039 -242 2 12.85 0.37996 5.63415 -2.0272 -10.2183 1.79381 -243 2 13.182 17.8392 6.59435 1.6098 2.02728 -12.9685 -244 1 0.276709 2.57627 0.11216 -0.0492842 3.76989 10.2262 -245 2 17.9528 2.7291 18.6895 13.0336 8.33648 -1.41355 -246 2 0.811706 3.36861 0.368499 -21.4808 -7.42382 -6.02819 -247 1 12.6714 10.9997 9.76016 -23.5437 -7.71308 -4.31472 -248 2 11.7133 10.8659 9.59681 15.3229 11.3368 0.532821 -249 2 12.914 10.0869 9.9422 13.3726 -3.72203 6.47581 -250 1 0.779958 12.2601 11.0819 -4.3547 -6.1438 5.62044 -251 2 18.4678 12.2984 11.1653 -6.51403 -1.20026 -7.70008 -252 2 1.07438 12.4529 11.9792 8.34734 4.57522 -3.24255 -253 1 5.0586 7.24501 13.467 -14.0099 -7.28532 -8.10759 -254 2 5.49528 8.03405 13.1289 12.6282 1.90126 -2.15469 -255 2 5.51501 6.98287 14.2704 7.34444 5.85192 6.7727 -256 1 1.26105 6.94281 11.8301 -2.26861 -4.26975 2.97 -257 2 0.502637 7.2894 11.3564 -2.98104 -0.152382 -1.57853 -258 2 1.67901 7.71469 12.2201 5.00338 4.10874 -3.32488 -259 1 15.4732 9.48624 12.3091 -7.90575 31.4836 20.4854 -260 2 15.2888 10.4503 12.3878 3.68649 -17.5592 -11.9783 -261 2 15.3484 9.17907 13.2194 3.56004 -6.14635 -9.9625 -262 1 16.6235 12.9071 5.45115 4.22183 -17.5767 13.0612 -263 2 16.4576 13.8585 5.58703 -5.89626 -6.38642 -16.4082 -264 2 16.4453 12.6107 4.54016 -1.61972 14.741 3.30454 -265 1 6.17978 10.0207 0.140312 6.69901 -0.902574 1.02107 -266 2 5.53175 10.4562 0.704359 -7.04498 -0.0752206 -3.29626 -267 2 6.99223 10.1412 0.643131 5.59964 -6.49227 2.85612 -268 1 12.3558 6.06094 4.04059 -1.82306 -10.4932 18.2897 -269 2 12.2948 6.89378 3.5711 -3.30175 6.87328 -14.7087 -270 2 11.4523 5.72881 4.15047 2.03572 4.51633 -5.92335 -271 1 0.151611 12.8143 0.201399 6.45324 -5.46068 -3.81056 -272 2 -0.0140355 13.4798 0.883392 3.4035 3.37155 -1.9342 -273 2 18.3672 13.1447 18.0414 -1.87626 -1.08321 2.97259 -274 1 3.81145 18.5877 8.5912 1.31461 -3.73146 5.16785 -275 2 3.56882 18.0432 7.82418 -6.49798 6.54364 1.53441 -276 2 2.99788 0.372962 8.89657 -5.11276 -3.31294 -4.1744 -277 1 7.4281 17.2705 4.47377 6.46179 23.4452 -11.2721 -278 2 7.96797 18.0618 4.61565 -3.66399 -5.46425 9.5792 -279 2 7.28703 17.3462 3.52078 -0.310988 -11.8901 2.26571 -280 1 9.22893 17.063 12.2466 22.6161 -18.3078 -0.374418 -281 2 9.25634 16.2959 11.6379 -2.98004 10.6911 5.23864 -282 2 10.0783 16.9759 12.7442 -18.2994 12.1316 -6.13803 -283 1 13.3197 12.9538 7.95187 -9.96581 2.72298 -9.05352 -284 2 13.2593 12.2563 8.62517 4.24613 3.77329 1.00191 -285 2 13.899 13.6706 8.22561 11.1032 -0.425478 9.75376 -286 1 14.9719 2.96045 15.3396 1.81329 0.120121 -0.870248 -287 2 14.3995 2.21229 15.1018 3.59949 7.50345 -3.65154 -288 2 15.6901 3.005 14.6772 -10.8991 -3.85704 4.22675 -289 1 9.85324 15.5257 17.0014 3.97317 -4.57748 -3.47476 -290 2 10.3864 14.7538 16.7592 -3.54516 -0.814303 -2.23392 -291 2 9.2485 15.2429 17.6987 -0.194096 3.36496 6.55889 -292 1 11.2976 8.26736 16.5426 7.06128 19.5884 6.19806 -293 2 10.6048 7.82655 16.0501 -2.15009 -7.46249 -5.1526 -294 2 11.6506 7.64084 17.1804 -3.23764 -5.26669 1.48715 -295 1 3.80261 18.1891 16.7286 5.96532 3.63646 9.58286 -296 2 4.2558 17.5705 17.3068 2.57751 -13.4277 -2.28373 -297 2 3.88923 0.356458 17.2317 -6.08372 7.81341 -6.39572 -298 1 2.19516 4.11859 8.94937 -6.46461 1.56382 -5.27436 -299 2 3.07192 3.77694 8.7043 -7.24867 0.753394 12.5906 -300 2 2.01364 3.98399 9.90559 16.1239 2.6739 -11.0998 -301 1 9.88488 10.3605 9.72172 5.12637 14.4569 -2.91242 -302 2 9.60959 11.2332 9.33432 -0.0101703 -19.6763 14.6837 -303 2 10.1282 10.4603 10.6632 -8.0115 2.48909 -7.97128 -304 1 9.71465 0.804575 10.8512 21.7431 15.3431 10.1505 -305 2 9.2832 18.6897 11.2643 -8.53487 -4.69507 -4.97966 -306 2 9.18676 1.22081 10.1628 -13.1132 -5.80645 -3.94121 -307 1 9.20675 15.1716 10.2106 -23.935 -1.88548 4.57185 -308 2 8.85892 15.9372 9.71979 2.38257 -5.68301 1.50138 -309 2 8.39577 14.638 10.4071 17.7258 6.53325 -11.5344 -310 1 1.0072 9.34307 10.3251 -13.5607 -2.30165 -2.87521 -311 2 1.0259 10.3094 10.4263 12.3488 -1.76633 0.307332 -312 2 1.88127 8.96784 10.1532 -1.03643 13.7416 3.72628 -313 1 16.8438 4.87108 8.18901 -4.78961 0.896955 11.5039 -314 2 16.1406 5.46499 8.54396 15.0863 -10.4307 -3.41532 -315 2 17.2081 4.33923 8.92353 -6.78534 8.8584 -10.8667 -316 1 14.6587 14.7041 0.366828 1.30507 -0.478814 3.63059 -317 2 15.185 15.0332 1.12636 -7.04307 -0.464202 -11.0373 -318 2 13.8385 14.3426 0.742198 8.82268 0.591631 -2.33039 -319 1 3.54036 11.0513 9.61487 2.50715 2.61524 -7.45538 -320 2 3.63629 11.5626 10.435 -2.71976 -6.10697 -0.243655 -321 2 3.06413 11.634 8.99273 6.16009 -0.263385 5.30284 -322 1 11.0628 10.8412 1.29387 1.94664 2.31063 1.36488 -323 2 11.3352 11.6508 0.816723 -4.4237 -7.82009 8.11802 -324 2 10.1138 10.7005 1.1254 8.25661 2.0034 -0.662671 -325 1 13.2071 7.092 12.8743 -8.181 6.96481 -7.78695 -326 2 14.1492 6.89693 12.9368 4.59729 -0.0390769 -2.26511 -327 2 12.7747 6.23567 12.7699 0.0352738 -4.27477 4.68983 -328 1 9.62872 1.89049 0.957357 1.17656 -1.16236 13.2501 -329 2 8.73134 1.77169 0.632677 -1.73422 -2.0126 -6.33446 -330 2 10.2301 1.88378 0.211292 -0.739962 2.15457 -7.7161 -331 1 10.5914 13.525 4.7165 6.94092 6.03141 -14.7136 -332 2 11.5001 13.1966 4.5902 -6.55933 -2.4681 12.9436 -333 2 10.616 14.067 5.5206 3.43098 -5.16043 -1.25188 -334 1 14.3018 1.72484 10.9172 13.4371 11.1223 -9.93713 -335 2 15.1272 1.43467 10.5035 -1.81024 -10.6133 4.43081 -336 2 14.4134 2.68551 10.8564 -6.433 0.422524 6.62217 -337 1 14.6521 12.3877 11.7022 -8.45049 -6.71538 5.80805 -338 2 15.5103 12.5052 11.2413 -17.7577 -5.57988 -7.54306 -339 2 13.9188 12.0751 11.1197 22.5147 4.82958 0.534535 -340 1 8.2427 5.06906 9.80652 6.55588 21.6544 3.19941 -341 2 7.41824 5.23391 10.2944 2.41744 -11.9303 -3.89737 -342 2 8.21758 4.20856 9.37923 -10.585 -10.7296 4.55255 -343 1 1.58459 16.8369 18.3321 1.96955 3.78018 0.59611 -344 2 1.85004 17.2184 17.4898 0.0469727 3.49377 1.52109 -345 2 1.98826 15.9645 18.3052 -5.87072 -8.1408 0.0386171 -346 1 1.45085 17.2397 15.3384 19.3024 -11.6024 -7.75777 -347 2 1.52928 18.1033 15.7334 -7.82156 13.9033 4.46915 -348 2 0.523156 17.01 15.2404 -5.15812 1.64021 5.22009 -349 1 3.71432 5.60797 6.16821 -6.42766 23.1509 5.2389 -350 2 3.10788 6.20238 6.65309 4.74203 -10.8724 -0.844938 -351 2 4.31902 6.23597 5.73943 -0.58891 -7.80382 -7.69424 -352 1 12.3617 9.44178 14.1897 14.768 -21.5294 -7.13739 -353 2 12.6854 8.60646 13.7318 -7.61852 23.4532 21.1317 -354 2 12.1886 9.19254 15.1239 0.0190459 -2.13671 -14.4759 -355 1 4.02789 15.2847 6.90037 19.6963 3.91174 -8.53909 -356 2 3.59813 16.0446 6.4807 -5.57314 -2.58109 7.58101 -357 2 4.98627 15.4174 6.72455 -14.0806 -2.64155 5.91133 -358 1 0.604694 8.56382 14.8836 6.38519 14.8729 2.46932 -359 2 0.593576 9.52815 15.0331 -4.38489 -7.16014 1.99766 -360 2 1.21683 8.48632 14.1406 0.0450847 -3.26888 3.80333 -361 1 12.9907 8.33553 10.3435 -10.7244 11.0212 -25.595 -362 2 13.7217 7.85043 9.92864 1.48882 -4.14748 10.5805 -363 2 12.916 8.06476 11.2563 9.06532 -10.0671 12.5191 -364 1 15.3021 7.67479 3.50456 -15.706 -31.6797 19.6454 -365 2 14.5991 7.08356 3.22123 -2.84665 13.9574 -20.9494 -366 2 15.4859 7.21773 4.34079 18.8178 22.1978 3.49889 -367 1 17.3057 6.66581 0.0439089 -0.566439 -0.157214 -4.14934 -368 2 16.9415 5.80914 0.322205 -4.36129 9.908 -1.962 -369 2 16.5386 7.21525 18.4101 8.51434 -8.37768 3.91558 -370 1 8.82219 6.93132 7.84612 -10.1525 -9.67927 6.48857 -371 2 9.74438 7.17539 7.82243 13.4851 9.91198 -3.74634 -372 2 8.75511 6.31699 8.60098 -3.86074 2.18846 -4.69843 -373 1 12.3417 0.621389 1.18077 -6.9564 -3.41972 6.83906 -374 2 13.1525 0.726993 1.70017 3.48999 0.0677543 -9.59522 -375 2 12.4857 18.5505 0.551479 3.63823 3.88808 0.842467 -376 1 5.6677 15.1168 14.5202 -2.89809 14.409 3.62726 -377 2 4.73779 15.2069 14.7798 -2.10515 -4.92641 -4.42493 -378 2 5.95698 16.02 14.2745 1.37709 -12.0745 -2.57764 -379 1 3.85174 6.50812 1.71549 -1.87326 -9.92841 -7.94113 -380 2 3.40118 7.27684 1.32447 4.40945 3.56133 7.79633 -381 2 3.98293 6.6854 2.65555 -2.72837 5.07562 -0.486349 -382 1 3.88774 11.6179 12.2731 7.36248 2.53406 3.74193 -383 2 4.74563 11.9961 12.5096 3.21135 -1.44769 -3.24982 -384 2 3.26188 12.2215 12.6852 -7.1456 -2.35069 3.20446 -385 1 5.4326 3.86602 15.8669 5.46195 27.5847 5.5501 -386 2 6.12196 3.19729 15.7751 -0.292732 -1.96119 -5.07149 -387 2 5.89955 4.7414 15.9262 -11.6823 -23.746 -2.53289 -388 1 14.4519 10.31 4.40466 -0.198609 -22.4452 -14.1251 -389 2 14.647 9.76314 5.18938 0.972168 3.21729 -6.37484 -390 2 14.6939 9.77999 3.59617 -3.45576 13.8176 24.0335 -391 1 7.91012 17.3396 9.21881 -3.47249 -5.09989 3.31179 -392 2 7.12992 17.5549 9.76562 5.48476 5.05439 -11.164 -393 2 8.00718 17.9294 8.44912 -7.46491 1.16212 7.11091 -394 1 4.51961 14.4455 3.97665 1.46094 13.6517 19.4367 -395 2 4.57851 15.3966 4.28178 1.46521 -27.5553 -6.05216 -396 2 4.65578 13.8277 4.74009 -3.41874 17.0045 -15.0106 -397 1 14.2914 7.39173 15.7568 2.67151 4.01398 13.8033 -398 2 15.2382 7.26829 15.5879 -5.04223 1.8615 0.0507223 -399 2 14.2621 7.71182 16.6758 1.37252 -0.910778 -10.0112 -400 1 2.89282 18.2219 1.89623 16.0954 20.7868 19.4211 -401 2 2.43498 17.5738 1.38145 -10.8581 -14.0242 -17.961 -402 2 2.20473 18.7378 2.33948 1.00824 -0.59586 0.163903 -403 1 7.97772 1.60288 4.53639 1.7563 -9.68985 13.008 -404 2 7.31922 2.029 3.97737 7.04095 6.46018 -8.6135 -405 2 8.84264 2.02013 4.43356 -4.53303 1.60821 -5.92451 -406 1 2.59943 14.1332 17.7414 -8.95394 -18.2677 -2.38171 -407 2 1.94944 13.4122 17.9464 12.5244 20.6844 1.19004 -408 2 3.47205 13.7759 17.9983 -8.8914 0.728457 0.900702 -409 1 0.745112 1.69912 13.8711 11.2473 3.52367 -11.146 -410 2 0.914419 1.4049 14.7673 -7.77297 1.70239 6.88788 -411 2 18.4589 1.93825 13.7842 -0.334419 -0.897106 4.15254 -412 1 4.53599 18.6175 13.9535 -3.4557 6.59794 -4.70782 -413 2 5.46815 18.3485 13.9788 -8.18255 -2.00556 -1.03369 -414 2 4.11637 18.3402 14.7801 5.6735 0.958275 2.99437 -415 1 7.096 0.531319 18.3551 -0.694611 7.4496 8.80978 -416 2 7.23097 0.178113 17.4735 2.95576 -3.96306 -6.42653 -417 2 6.14085 0.633472 18.4745 3.33236 6.58102 0.363951 -418 1 16.0915 18.4336 14.0959 0.427379 -0.396215 -8.58483 -419 2 15.3508 17.8946 13.7703 3.59427 8.97013 10.1541 -420 2 15.9721 18.7209 15.0186 -4.35198 -12.8399 -3.85995 -421 1 10.0849 4.5187 16.2702 4.73223 -5.50586 5.92697 -422 2 10.9866 4.63155 16.5807 5.77761 8.19399 -3.69287 -423 2 10.0461 3.5611 16.1717 -6.80252 -1.66686 -4.51665 -424 1 15.8725 17.8845 4.41654 -12.5209 12.7326 5.37596 -425 2 16.3916 18.7124 4.49019 -1.68969 -11.5252 -1.94643 -426 2 14.9593 18.1341 4.67479 17.449 -5.50076 1.40971 -427 1 6.95668 17.3709 13.7302 27.0332 5.97859 23.7699 -428 2 7.35597 17.5596 14.624 -6.60353 0.436933 -26.7426 -429 2 7.73328 17.3113 13.1176 -17.9234 -0.691624 11.5164 -430 1 13.2886 6.54141 6.708 -19.4099 -8.32294 21.4331 -431 2 14.1944 6.83212 6.62317 10.4169 5.52785 -11.9279 -432 2 12.8902 6.38702 5.85009 7.8467 0.777822 -14.5162 -433 1 7.70655 2.38278 9.20977 12.6343 0.60353 -10.8933 -434 2 7.2325 2.23152 10.0347 -6.87682 0.627979 2.4454 -435 2 7.14224 2.1131 8.46352 -1.96859 -1.38987 10.9664 -436 1 15.1599 14.8609 13.6555 2.14917 -2.72077 3.1958 -437 2 15.0894 15.1454 14.5818 -4.10533 -0.470809 -6.08849 -438 2 14.3857 15.1548 13.1581 4.50097 1.9243 4.2209 -439 1 9.31836 8.32368 3.71602 18.5592 -2.51714 11.5674 -440 2 10.1335 8.79007 3.99631 -8.14035 -3.14117 -4.90658 -441 2 9.4898 7.3827 3.90713 -7.2783 5.8685 -3.93333 -442 1 17.7186 13.4905 16.4359 -1.51289 22.2408 -13.156 -443 2 16.7625 13.3639 16.3649 1.62841 -7.26982 3.16217 -444 2 17.8329 14.3608 15.9953 4.68582 -10.1291 6.26608 -445 1 5.02763 10.6563 2.64305 -2.13744 -9.22816 3.31541 -446 2 5.67739 10.1782 3.18798 -3.0773 8.85482 -0.1212 -447 2 4.59818 11.3042 3.21285 3.70326 -1.5106 2.19329 -448 1 3.72149 8.34459 10.2919 -0.179455 -7.68631 -12.7595 -449 2 3.82782 9.26393 10.0171 0.460185 9.10653 3.72446 -450 2 3.7984 8.31763 11.2506 0.24707 1.5831 -0.943414 -451 1 16.0782 7.09232 6.27704 3.78536 -20.3998 -1.61032 -452 2 16.8668 7.5306 6.63092 -6.12864 4.03671 -1.53431 -453 2 16.2929 6.14181 6.32149 -2.48234 12.3559 -4.92911 -454 1 15.1572 7.02511 9.10581 3.8117 16.1939 -22.7388 -455 2 15.9823 7.33517 9.52567 -10.9007 1.4123 -2.48218 -456 2 15.0452 7.59247 8.29613 6.45133 -12.7204 22.5185 -457 1 6.42341 13.1088 12.8743 -8.95622 -6.97199 -8.56847 -458 2 7.13157 12.5608 13.2501 0.579484 9.04377 -2.95583 -459 2 6.27581 13.8943 13.4207 1.62934 -6.42573 5.92996 -460 1 12.1251 4.48872 13.0852 20.6978 11.8008 -11.4801 -461 2 12.1861 4.63134 14.0408 -7.38726 -2.06828 2.45652 -462 2 11.3124 4.06154 12.8314 -12.072 -7.43803 9.29181 -463 1 11.3394 8.19587 7.85205 11.1059 -10.4301 17.8484 -464 2 12.0348 7.61277 7.52234 0.357557 0.521252 -13.0071 -465 2 11.6101 8.269 8.78041 -6.91702 7.4869 -1.95681 -466 1 17.1867 10.7889 7.4395 14.5297 -2.81026 -23.5185 -467 2 17.9096 10.1869 7.16109 -12.9834 1.71839 15.1597 -468 2 17.0415 11.3048 6.62611 -4.1729 8.16775 12.482 -469 1 5.24074 18.1281 11.0581 -15.2173 -3.98599 -8.34189 -470 2 4.58924 18.0057 11.7782 10.2636 1.95052 -8.13419 -471 2 4.73144 18.0737 10.2167 7.33147 4.07832 13.9505 -472 1 7.57528 17.5815 1.8237 -4.07192 12.6902 15.9513 -473 2 7.93668 16.805 1.40258 -2.93669 -7.99436 -16.24 -474 2 7.56667 18.3008 1.17772 -1.22407 -7.09592 -6.98677 -475 1 1.89335 12.9293 13.6081 -2.83392 -4.38044 7.70492 -476 2 1.42634 12.2947 14.1785 7.13969 5.03303 -2.73416 -477 2 2.14611 13.6729 14.1857 -2.01709 -2.63559 -9.61881 -478 1 9.71667 6.79197 14.8165 -19.737 27.0922 8.68981 -479 2 9.89359 5.91802 15.1417 7.60675 -24.7177 2.15595 -480 2 10.032 6.8882 13.9194 5.10262 -3.22926 -9.37061 -481 1 15.2334 4.35765 10.7756 -27.5978 -16.2477 -22.3588 -482 2 16.1684 4.22394 10.6591 16.9939 1.30069 13.5789 -483 2 15.041 5.04225 11.4098 10.4595 11.1452 11.1309 -484 1 11.214 6.13659 0.181715 -19.0514 -14.6776 -12.5318 -485 2 11.2124 5.17659 0.0304417 14.0569 6.29109 5.62342 -486 2 10.2823 6.34718 18.6411 6.7491 10.3457 6.1137 -487 1 0.148583 11.3373 15.1258 -19.5821 15.0001 -24.2151 -488 2 18.1981 11.6758 14.382 16.6378 -5.64999 24.2973 -489 2 18.7581 12.0391 15.8029 -7.9684 -6.15355 -5.02438 -490 1 7.07881 9.17505 7.27008 -6.43803 -1.74166 -4.58486 -491 2 6.45798 8.45812 7.48524 7.10939 3.15379 4.24177 -492 2 7.95401 8.76045 7.26417 -3.66954 2.28396 2.09633 -493 1 18.4168 15.4276 12.3546 -3.43386 -0.549873 -4.48624 -494 2 0.729474 15.5504 12.2627 0.527014 -4.05801 2.94094 -495 2 18.0745 15.7474 11.5108 -2.98934 0.409485 0.218187 -496 1 16.554 4.36499 5.23729 20.8954 -6.05263 25.9175 -497 2 16.7683 4.14077 6.16822 -16.8827 1.59137 -12.628 -498 2 17.4495 4.42836 4.87212 -5.6372 6.04853 -15.3532 -499 1 17.7678 3.07292 10.7257 -2.33819 12.1961 -2.64827 -500 2 0.05876 3.27172 10.9273 -5.50289 -7.01135 -0.383438 -501 2 17.6798 2.21428 10.2822 5.02163 -0.151153 2.81987 -502 1 12.2925 0.0394171 10.1485 -5.03026 26.5344 11.6637 -503 2 11.4572 0.407352 10.526 9.87088 -12.259 -12.5756 -504 2 12.9102 0.803778 10.1803 -6.63246 -15.2789 0.0865208 -505 1 10.3587 9.80679 12.3603 15.6128 10.3756 0.750657 -506 2 11.1656 9.89562 12.9016 -9.14674 -1.49827 1.04164 -507 2 10.2822 8.8615 12.2126 -4.78815 -8.04326 1.85351 -508 1 0.512396 2.83902 7.01376 3.84696 0.0782361 15.1378 -509 2 0.640445 3.53836 7.66576 0.959953 5.26089 -8.6545 -510 2 0.680944 2.06786 7.56376 2.06531 -6.50055 -6.8896 -511 1 0.435055 15.2675 6.92024 15.2549 -35.398 4.87844 -512 2 0.621058 15.2814 7.87767 -6.30652 4.63478 -5.55491 -513 2 0.767833 14.3496 6.68755 -16.1257 30.2961 -2.9732 -514 1 16.9932 7.01767 15.3053 -26.5651 1.45521 -6.17716 -515 2 17.7481 7.60304 15.1777 11.1425 -6.61607 -1.97906 -516 2 17.2478 6.0923 15.4082 16.5215 2.79636 5.68328 -517 1 9.018 12.4253 8.12635 6.95093 19.302 15.9025 -518 2 9.42759 11.8305 7.48541 -10.9396 -6.20971 -13.8418 -519 2 8.05723 12.5431 8.02215 9.94353 -10.4145 -8.12359 -520 1 1.2603 1.92339 3.03777 4.00037 -11.2111 -0.333139 -521 2 0.985763 2.4239 2.25859 3.27899 1.87382 4.37683 -522 2 1.94434 2.40743 3.53125 -8.95634 4.24445 -6.71947 -523 1 4.13152 15.1081 9.6737 -15.9579 5.42681 13.2475 -524 2 4.06185 15.276 8.72578 6.37214 -2.02945 -0.454299 -525 2 5.01049 14.775 9.87491 6.77649 -3.08542 -5.82222 -526 1 7.18656 2.18024 14.5742 6.63684 0.423238 1.66106 -527 2 6.97291 1.78224 13.7284 -0.102066 -5.66692 0.745345 -528 2 7.71431 2.94579 14.3335 0.160548 4.26015 2.86325 -529 1 18.6004 14.6938 2.16823 2.76542 -5.02319 -0.780568 -530 2 0.802927 15.1539 2.18876 5.80577 -4.93168 -0.456722 -531 2 17.9585 15.3989 2.13554 -15.1748 6.08707 3.47143 -532 1 9.94779 2.77101 12.9402 13.7079 -4.8088 0.992354 -533 2 9.86912 2.18708 12.1681 -6.43941 0.85112 1.08944 -534 2 9.26112 3.44421 12.9098 -9.63803 -0.00730006 -3.05418 -535 1 2.82654 8.93218 13.0337 -16.8853 -9.00607 0.122573 -536 2 3.25687 9.752 12.7946 6.59476 15.835 -2.70012 -537 2 3.50997 8.32082 13.3007 12.5319 -6.06263 8.37491 -538 1 3.22862 8.37837 3.65188 -0.226515 1.69475 29.0088 -539 2 3.688 9.03214 3.10752 1.26352 6.15003 5.24259 -540 2 3.37942 8.56962 4.62044 0.873457 0.138782 -29.442 -541 1 5.6209 7.19208 8.52428 9.74274 9.28918 -7.76376 -542 2 5.82768 6.24803 8.58864 -11.1579 -1.95789 2.42461 -543 2 4.98617 7.45468 9.2041 -0.288223 -8.23268 4.91577 -544 1 14.8711 1.29057 2.00464 8.31119 17.2873 -6.28041 -545 2 14.835 2.11415 2.48745 -9.33397 1.40045 17.6104 -546 2 15.2356 1.62076 1.17953 -0.998754 -14.9614 -12.238 -547 1 8.25883 15.2026 0.830681 5.29747 -5.49957 9.6471 -548 2 8.95156 15.1522 1.50066 13.8019 -1.55539 -6.59484 -549 2 7.5748 14.6468 1.22478 -8.81297 0.605757 -6.77665 -550 1 15.6232 1.34362 7.23598 -18.647 -1.91314 -11.6656 -551 2 14.9897 0.764646 6.76092 12.0508 5.58891 7.1025 -552 2 15.1447 2.18632 7.33027 3.5178 -4.19741 5.22167 -553 1 4.94904 13.0769 18.5237 9.6722 0.589191 0.374268 -554 2 5.36668 13.208 0.749415 -4.04426 -2.7658 -6.21312 -555 2 5.63686 13.3362 17.8955 -3.04446 1.7017 1.4528 -556 1 15.3696 8.47999 18.1528 -1.21138 17.1653 -12.6794 -557 2 15.695 9.10606 17.469 -1.13375 -12.9806 6.06144 -558 2 15.1122 9.07709 0.225504 3.72099 -3.98362 5.25331 -559 1 12.0892 3.03182 18.3639 -14.1234 30.4246 -7.06661 -560 2 12.0418 2.65673 0.600248 11.0312 -14.2758 -1.1161 -561 2 12.4684 2.43863 17.7097 5.58993 -13.4699 6.64437 -562 1 13.2076 12.6677 5.18878 -11.1257 12.6934 -18.8931 -563 2 13.6382 11.873 4.85103 6.50507 -2.50005 7.23376 -564 2 13.4408 12.7972 6.11334 1.90386 -8.97209 5.02297 -565 1 6.04179 7.07685 0.0416979 2.64097 -12.2137 0.441028 -566 2 5.97681 7.98433 18.9573 -0.86164 23.926 -2.06041 -567 2 5.22747 6.68409 0.369779 -2.28588 -4.24693 2.31783 -568 1 17.7316 15.9939 15.0114 -15.9363 1.83518 -2.01139 -569 2 16.8954 16.4456 15.035 -7.98632 8.38962 22.0218 -570 2 17.7728 15.8943 14.0703 21.4922 -14.9825 -23.1623 -571 1 13.1856 0.993654 16.5812 4.51688 -6.04585 -7.39508 -572 2 14.1484 0.841574 16.6066 -7.22778 -1.30407 6.3933 -573 2 12.7998 0.141541 16.3207 3.39554 1.08214 8.76474 -574 1 11.0918 14.5789 7.23122 -0.0827639 9.53574 4.16562 -575 2 10.4295 14.1218 7.74457 -13.7426 -4.81361 3.6986 -576 2 11.9118 14.1808 7.52276 7.59678 -9.08814 -4.3045 -577 1 17.5016 8.6119 2.09076 15.8147 11.2146 7.10458 -578 2 16.6678 8.4072 2.52184 -8.49554 -5.1851 -0.954934 -579 2 17.6089 8.02126 1.34907 -7.08963 -15.2245 -7.94382 -580 1 12.3468 7.97644 1.98939 8.16003 1.60059 13.0036 -581 2 12.1059 8.91014 1.92161 -4.12319 -5.14517 -8.91961 -582 2 11.9653 7.48445 1.25112 -3.43761 0.267259 -0.201848 -583 1 11.9018 14.6174 10.3415 -1.61415 6.01794 0.545715 -584 2 12.1103 13.7968 9.87035 -7.85836 7.68399 3.13223 -585 2 10.9576 14.8558 10.2015 13.8599 -12.9225 1.87067 -586 1 6.88302 7.0351 15.5985 0.0361083 -3.88964 -3.36213 -587 2 7.78537 7.14813 15.233 -9.24764 2.66089 10.2853 -588 2 6.74206 7.63616 16.3488 6.91006 -2.15529 -8.72434 -589 1 7.99721 4.71198 13.4628 5.66523 -8.00363 0.660216 -590 2 7.27921 4.81457 12.8289 -1.54019 0.966988 -4.0678 -591 2 8.48375 5.53924 13.4635 -1.88422 3.21799 -0.709238 -592 1 13.4036 12.1691 14.2716 3.14721 5.94494 7.46154 -593 2 13.2707 11.2057 14.207 -2.45791 4.15826 -3.3873 -594 2 13.8696 12.4652 13.4742 -1.1423 -6.74147 -2.23487 -595 1 14.8179 9.43426 7.29668 -6.36233 -11.9657 -8.30628 -596 2 15.5946 9.98871 7.43973 -1.00608 2.08043 5.84882 -597 2 14.0417 9.81939 7.70717 2.29675 7.38462 3.05591 -598 1 12.6631 17.0342 3.08686 -0.647851 26.0284 13.2632 -599 2 13.0189 17.4392 3.9047 -6.62985 -13.126 -8.67274 -600 2 12.0984 17.7464 2.72355 6.77056 -16.0012 0.625123 -601 1 1.16659 7.14982 17.4488 -22.2539 0.168591 -14.6305 -602 2 0.289944 6.86023 17.7803 4.99818 12.4666 0.0121858 -603 2 0.976074 7.62854 16.6106 6.60301 -8.93429 9.27073 -604 1 12.7913 5.13723 15.6659 26.8924 -5.83385 4.65231 -605 2 13.5397 4.50448 15.7352 -14.8898 5.20509 -1.35689 -606 2 13.2524 6.00122 15.6738 -9.3883 -7.24139 -3.09335 -607 1 2.50717 3.39641 5.02544 -4.94238 4.99772 43.075 -608 2 1.86502 3.10611 5.74586 16.3729 8.7954 -24.7542 -609 2 3.07143 4.08677 5.47722 -17.3542 -15.0389 -19.8763 -610 1 8.33721 11.2536 13.4671 -31.8218 12.3906 11.8554 -611 2 8.27902 11.0779 14.4347 20.4393 -8.01279 -19.4916 -612 2 9.11607 10.9377 12.9927 6.53682 -12.2231 14.6875 -613 1 12.8982 1.36842 13.3393 -2.38428 13.9081 -24.9925 -614 2 13.3657 1.32357 12.4816 4.13856 -5.14841 14.3736 -615 2 12.4149 2.20238 13.2267 1.28817 -6.58848 11.7421 -616 1 6.36101 13.6632 2.13728 5.84509 3.64922 20.165 -617 2 5.80267 14.0802 2.81815 -1.42815 -2.61112 -9.48922 -618 2 6.96781 13.1347 2.6793 2.58248 -4.73497 -8.11447 -619 1 15.9275 6.58906 12.776 -13.2255 -11.9143 -7.63467 -620 2 16.5079 7.05171 12.1721 3.66176 7.36442 -5.52267 -621 2 16.2877 6.70509 13.653 8.87525 3.50761 9.55012 -622 1 16.8403 0.7053 9.59425 -10.8287 -6.51914 0.180126 -623 2 16.6786 18.4058 9.8215 7.5744 10.512 -7.34073 -624 2 16.3431 0.86575 8.76743 6.96547 -2.88011 1.97602 -625 1 6.14042 11.7236 8.37935 -13.4401 -40.1875 -12.4491 -626 2 5.21965 11.5178 8.67227 17.9013 7.59491 -1.88002 -627 2 6.47134 10.8481 8.01351 -3.81201 28.7474 13.2691 -628 1 2.85976 8.65216 0.41009 29.1416 -12.2873 -0.261225 -629 2 2.35956 8.19684 18.3517 -12.3126 13.3733 12.5274 -630 2 2.40304 9.34487 0.902258 -18.8466 -1.4582 -10.1697 -631 1 10.1473 10.4614 6.51315 3.14709 -2.48115 -1.63688 -632 2 10.5898 9.76783 7.02035 -1.8228 -0.602608 0.477386 -633 2 10.6086 10.4674 5.65949 -3.20151 3.83187 3.87642 -634 1 6.7508 15.7003 6.55579 -3.66232 16.9823 8.74149 -635 2 7.17195 16.1106 7.3235 -0.889674 -7.99055 3.10182 -636 2 6.78205 16.4211 5.90999 7.33374 -8.97986 -9.58603 -637 1 6.44532 13.1371 5.60194 -4.00449 -9.15456 -0.382904 -638 2 6.60496 14.011 5.98141 3.67218 -1.64471 2.17047 -639 2 6.02503 12.5975 6.28414 2.5909 4.19611 1.89612 -640 1 16.8064 12.5561 9.82402 0.581653 -6.91502 5.14494 -641 2 16.9779 11.8749 9.14515 -1.61791 10.9714 -1.54419 -642 2 16.8208 13.4318 9.41997 2.06437 -4.78596 -5.13994 -643 1 6.05928 2.9442 2.82556 1.25802 -7.30262 2.82421 -644 2 6.27309 3.83898 2.57954 7.79966 17.9541 1.71249 -645 2 5.71238 2.57735 2.0082 -4.75947 -10.8151 -3.84195 -646 1 10.8984 3.29285 3.29228 5.15622 -3.79068 5.20633 -647 2 10.3299 4.01236 3.59418 -0.748764 -1.25701 -6.51467 -648 2 10.5397 2.95527 2.46424 -5.70132 0.188995 -0.608043 -ITEM: TIMESTEP -30 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.74009 7.04233 17.938 19.1777 -3.19214 -7.49225 -2 2 7.80649 7.00854 18.1244 -14.093 -2.50808 3.42214 -3 2 8.91581 6.41795 17.2214 -5.10918 0.448792 4.2696 -4 1 18.6171 8.27942 6.83462 -12.32 14.9255 -3.46236 -5 2 0.0642234 8.14825 5.88022 8.8384 -8.96826 -1.74433 -6 2 0.471057 7.61284 7.31078 8.78566 -8.6497 2.36561 -7 1 8.41948 18.604 6.83196 -7.31709 9.89495 0.0475112 -8 2 9.31705 0.18142 6.57583 5.64527 1.22556 -0.782264 -9 2 7.87491 0.677395 6.4693 3.49499 -4.79599 0.294282 -10 1 6.58709 1.81441 11.6738 -9.76955 10.2882 13.9968 -11 2 5.91112 2.25954 12.2323 7.89399 -9.20897 -13.0604 -12 2 6.23103 0.933026 11.5157 -4.21921 -5.78552 -0.720022 -13 1 7.09426 5.71845 2.37594 5.34919 -15.1759 8.94595 -14 2 6.67772 6.26147 3.06365 -7.93287 1.62685 -13.8275 -15 2 6.91151 6.0744 1.49958 -5.30903 10.9181 0.766926 -16 1 16.2033 10.1932 16.1102 25.1038 -14.8345 -4.68499 -17 2 17.1811 10.2276 15.9712 -26.7737 6.31541 3.48142 -18 2 15.8826 11.0697 16.3304 -0.495148 7.87416 1.92317 -19 1 10.6275 14.9681 2.33481 4.63974 12.4061 -8.88569 -20 2 10.5525 14.5877 3.21874 0.475518 -3.93386 2.29786 -21 2 11.1735 15.7673 2.45016 -5.17002 -7.496 3.37274 -22 1 17.1558 8.25893 10.4932 -6.40301 -0.466841 8.61163 -23 2 16.8014 9.01233 11.0035 2.41501 -9.01393 -1.96838 -24 2 17.9838 8.5563 10.1014 3.2569 5.37409 0.738347 -25 1 14.813 15.8567 16.3841 0.422148 6.97991 -3.34819 -26 2 13.9021 16.1825 16.382 -1.86689 -1.60487 0.125842 -27 2 14.9304 15.3999 17.2268 -3.27081 -1.81494 5.72738 -28 1 12.1434 13.4089 0.461034 6.76243 -11.3039 1.90058 -29 2 12.0273 13.3364 18.1404 -4.47443 10.9984 5.76772 -30 2 11.5266 14.0334 0.870976 -2.78837 -1.53089 -3.65161 -31 1 9.27697 5.43199 4.02458 -7.91052 -7.29997 -7.2337 -32 2 8.84655 5.10212 4.83549 0.848683 4.58319 -8.36746 -33 2 8.59135 5.35221 3.31849 12.3251 4.32217 11.9863 -34 1 1.81829 4.21991 11.6429 6.07059 -17.107 12.3126 -35 2 1.72876 5.16246 11.8251 -3.56412 5.27463 0.970751 -36 2 2.25117 3.81723 12.4298 -6.51129 5.35444 -16.475 -37 1 2.00161 6.82001 8.34658 4.25884 -4.64897 6.26816 -38 2 2.3883 7.2423 9.12712 0.123274 4.2764 -6.11357 -39 2 2.06217 5.87963 8.57415 -6.89287 0.824976 -4.38383 -40 1 5.40511 4.42179 7.95561 5.36611 -11.1614 7.9457 -41 2 5.37943 3.4545 8.00651 8.07147 0.734095 -1.60012 -42 2 4.74745 4.62621 7.29567 -7.31573 12.7226 -8.35968 -43 1 3.27976 2.92717 17.5269 -2.61436 17.3567 -5.43199 -44 2 3.96706 3.40529 17.0145 -5.77518 -10.9103 1.73426 -45 2 2.73687 3.63363 17.9263 6.62302 -5.15647 1.61932 -46 1 7.46558 5.28438 6.08942 -8.18758 20.8516 25.3808 -47 2 7.86532 6.07017 6.49581 9.60667 -5.12281 -7.79846 -48 2 6.93507 4.98822 6.84771 -4.13165 -15.5457 -12.384 -49 1 9.77734 7.00329 11.9774 4.77277 1.25087 12.6605 -50 2 10.3838 6.43919 11.4894 -2.2356 -0.795019 -4.50196 -51 2 9.03042 7.20515 11.401 -0.391647 0.322053 -6.58611 -52 1 14.0794 3.58589 8.07965 12.1281 -3.68665 15.0324 -53 2 13.9224 4.24013 7.41233 -5.94016 13.6931 -8.832 -54 2 14.4997 4.05823 8.8235 -7.49262 -7.6028 -6.06268 -55 1 4.66909 17.2524 3.98463 -11.974 -6.63251 3.44703 -56 2 5.54996 17.5659 4.2137 3.76078 6.9996 -9.15965 -57 2 4.29017 17.6906 3.19701 6.52868 -0.394456 6.67531 -58 1 16.4992 16.6027 10.1206 -21.6924 9.71885 22.6747 -59 2 15.7868 16.8403 10.7484 14.9981 -6.02669 -3.77625 -60 2 16.0155 16.0666 9.49209 1.7904 -6.99745 -11.6514 -61 1 1.97502 4.88502 0.412911 -0.608987 3.87721 -1.07962 -62 2 2.72637 5.27959 0.897705 -7.05745 -2.41863 1.64934 -63 2 1.49341 5.65258 18.7073 9.30006 -4.776 -0.647009 -64 1 11.7125 13.3331 16.298 -5.19121 -16.9939 -9.12414 -65 2 11.2215 12.495 16.3147 -7.17559 5.00423 10.7559 -66 2 12.3053 13.159 15.554 3.20757 8.82206 0.62976 -67 1 10.1364 11.0457 16.9267 -8.25027 -0.64471 -2.79768 -68 2 10.5138 10.1546 16.8726 -0.811727 0.343111 1.84422 -69 2 9.16904 10.9405 16.8614 10.4447 -1.98124 -2.23602 -70 1 11.7196 17.4866 13.4532 0.688277 4.88805 11.3616 -71 2 12.4565 17.1915 12.9059 2.31052 0.20251 -3.63622 -72 2 11.8417 18.4468 13.5823 3.75325 -8.25615 -8.02045 -73 1 6.38436 9.31353 12.2227 -10.6166 9.98881 15.1897 -74 2 6.82973 8.96514 11.4526 14.2312 0.227315 -7.303 -75 2 6.92633 10.0292 12.607 -0.115112 -8.7725 -6.80594 -76 1 16.2215 12.7689 2.69197 14.2202 2.36446 -2.70282 -77 2 17.0315 13.2181 2.42332 4.27042 -4.81366 0.268886 -78 2 15.6299 13.4985 2.86911 -16.5638 6.55953 0.86202 -79 1 0.643858 12.5819 5.90471 10.4355 0.0636689 -1.96923 -80 2 0.972356 12.3928 5.01972 -0.601341 2.21783 -2.79245 -81 2 18.3387 12.6591 5.78833 -5.81166 2.35718 1.0682 -82 1 5.2154 16.4273 18.4533 5.05017 -7.28804 7.26993 -83 2 5.85096 15.759 18.1791 -0.38035 -3.88529 -12.2081 -84 2 5.53459 16.6741 0.678671 -3.42073 7.449 3.19712 -85 1 0.551654 7.64481 4.10641 16.2354 21.1246 -10.5626 -86 2 18.6183 7.98546 3.39603 3.07966 -1.83327 6.1622 -87 2 1.42708 8.08449 3.93576 -19.267 -16.5837 1.18512 -88 1 3.12227 8.91534 6.50802 24.2291 -0.585626 7.1452 -89 2 3.7382 8.63748 7.22391 -17.1573 3.17125 -13.7643 -90 2 2.22482 8.81583 6.82729 -5.68465 -1.73896 5.22193 -91 1 7.30086 10.3189 16.2323 -15.6545 -0.122126 6.34207 -92 2 6.59019 10.5178 15.6183 5.33711 0.792532 -4.64 -93 2 6.81196 10.2023 17.0683 9.00195 1.1125 -0.831229 -94 1 11.1139 1.03369 5.01342 4.3303 1.68398 -12.6705 -95 2 11.3068 1.80352 4.46111 -2.07011 7.18197 9.97137 -96 2 10.7762 0.428462 4.34613 -4.44642 -9.51924 3.00218 -97 1 4.39584 2.7383 13.2149 -0.390466 4.89753 -17.2666 -98 2 4.70663 3.24132 13.9776 -1.24631 -10.9908 10.3904 -99 2 4.24133 1.79775 13.4334 4.65854 7.0575 9.14841 -100 1 8.38523 10.0971 1.80824 -1.28714 19.1329 -0.644156 -101 2 8.30354 10.8052 2.48172 0.822207 -7.93375 -7.37013 -102 2 8.79223 9.36658 2.27287 1.71369 -9.23717 4.71722 -103 1 10.4729 1.73916 15.5717 11.6995 -6.53653 -13.4069 -104 2 11.3877 1.45477 15.4183 -5.50109 4.13915 12.9036 -105 2 10.2466 2.11684 14.7151 -9.31794 0.949785 -3.28817 -106 1 2.72932 12.8923 7.77007 2.13638 -2.03638 4.95693 -107 2 3.24355 13.6603 7.47881 -3.48119 -3.6232 -2.9431 -108 2 2.14523 12.6528 7.03806 -2.13852 4.70731 1.87174 -109 1 3.67999 11.6951 5.25129 1.06179 2.30609 -7.65488 -110 2 3.48397 10.8814 5.71277 1.07183 -5.39866 6.20843 -111 2 2.98047 11.7882 4.59744 -0.426908 3.81831 -2.62473 -112 1 6.82829 14.472 16.8976 7.24547 -11.7087 -0.510459 -113 2 7.70535 14.0752 16.845 -3.98439 5.03843 1.85271 -114 2 6.50852 14.4918 15.986 -3.30226 9.38599 0.302494 -115 1 14.1912 14.5549 3.37889 -4.65321 -1.5346 -2.40618 -116 2 13.6567 15.3531 3.27958 4.16996 -0.562804 -5.50008 -117 2 13.6356 13.9417 3.87468 5.16163 -0.564442 6.07906 -118 1 8.32326 18.1549 16.0383 38.0123 0.723105 5.33509 -119 2 8.90126 17.4596 16.3629 -14.277 -18.5473 4.85232 -120 2 9.02384 0.130446 15.7883 -15.867 17.9211 -5.43461 -121 1 4.72767 1.62379 4.93271 -17.6379 -0.985038 1.9521 -122 2 3.81401 1.95679 4.84992 11.4813 -1.52324 3.97162 -123 2 5.23321 2.13073 4.30096 3.99283 5.81443 -10.8958 -124 1 15.0185 12.7583 16.4307 33.5549 -15.7429 -8.88385 -125 2 14.6322 13.2399 17.156 -17.5625 6.9837 5.99474 -126 2 14.4538 12.6352 15.6516 -10.3238 6.55553 8.00439 -127 1 15.7718 18.4254 16.841 -12.0797 -5.1952 -2.21012 -128 2 16.3284 18.515 17.6327 0.946096 -4.9786 -5.09166 -129 2 15.4084 17.517 16.8347 11.7053 8.22526 2.07191 -130 1 1.18057 1.17309 16.5558 11.0398 2.91722 -0.500753 -131 2 1.84524 1.84688 16.7601 6.86303 -5.43895 -3.7977 -132 2 0.618264 1.22767 17.321 -11.8887 1.06625 6.89733 -133 1 18.1125 4.54155 15.913 0.560198 2.18648 6.37111 -134 2 18.4591 4.08913 15.1466 2.75843 -6.08521 -5.17788 -135 2 18.7597 4.4472 16.6204 -1.36812 0.49592 -3.69459 -136 1 12.2402 16.9779 16.1352 2.31512 -6.99762 -15.3414 -137 2 11.5952 16.4515 16.6081 -8.3163 0.999648 8.5775 -138 2 12.0081 16.8315 15.1982 2.22798 9.47321 6.13039 -139 1 15.9623 2.53119 18.0207 2.93621 -4.28086 -0.122131 -140 2 15.5695 3.22825 18.5544 -2.43998 7.63429 -5.2422 -141 2 15.6676 2.68289 17.1026 2.19807 1.36349 7.25858 -142 1 6.70368 13.8359 10.2288 1.24588 -18.109 -1.49583 -143 2 6.57782 13.5214 11.1319 -1.51171 6.96132 4.85856 -144 2 6.68827 13.0063 9.72453 -2.19505 9.55036 -5.72862 -145 1 10.1309 18.2871 2.76796 -14.3596 -6.47533 0.342864 -146 2 10.2029 0.342366 2.11266 2.51428 7.52943 -3.11917 -147 2 9.22516 17.9366 2.63576 15.7336 3.88756 2.50188 -148 1 2.99532 17.7363 6.09725 27.6457 -0.367768 9.57951 -149 2 2.17297 17.7876 5.61616 -10.9588 -3.8104 -13.5012 -150 2 3.724 17.7747 5.44639 -16.7072 2.57282 0.579206 -151 1 12.5761 16.9143 8.00615 -13.9856 15.3012 3.95273 -152 2 11.7456 16.4539 7.8426 4.73348 -10.9119 -5.17088 -153 2 12.3021 17.5765 8.66814 13.2598 -3.61726 -0.932189 -154 1 14.882 15.2803 8.24971 10.681 -0.761738 -5.80123 -155 2 14.3225 16.029 8.07669 -22.8014 8.12514 9.31404 -156 2 15.4227 15.298 7.45407 7.11517 -7.78554 -3.15381 -157 1 17.6329 18.2578 0.365715 -0.853361 22.9802 4.00517 -158 2 18.5235 17.9699 0.161776 5.93848 -16.2402 -3.481 -159 2 17.7627 0.512218 0.708086 -5.13428 -6.58263 -1.39758 -160 1 0.88251 10.4012 1.38524 10.7451 13.2218 -5.20703 -161 2 0.0659506 9.93794 1.52098 -14.8693 -14.1338 10.0664 -162 2 0.630973 11.1288 0.804044 1.28572 5.25949 -2.19783 -163 1 1.64115 12.2217 3.35193 -3.18006 -13.1055 -18.8251 -164 2 1.37082 11.5062 2.75067 2.88651 -5.3868 11.6868 -165 2 1.67765 12.9428 2.72371 4.09986 15.3051 6.03005 -166 1 0.58147 17.2398 4.87485 -10.389 -0.219728 20.623 -167 2 -0.122589 17.8866 4.86961 1.40048 11.6397 -9.93657 -168 2 0.410626 16.8027 5.7206 11.49 -10.3372 -7.14723 -169 1 1.11352 0.964392 9.43077 -4.94184 3.64088 -20.8453 -170 2 1.20387 0.588778 10.3126 -0.847456 -3.79009 5.67247 -171 2 0.226103 0.72639 9.1141 8.25621 -1.04795 9.52173 -172 1 16.7603 2.33922 13.2874 -3.33679 -13.7714 7.5216 -173 2 16.8475 2.59005 12.3669 3.49604 3.27514 -7.50745 -174 2 16.539 1.38388 13.2956 1.74648 12.4468 1.52133 -175 1 2.56382 15.8252 12.169 -1.32309 5.18512 -19.2115 -176 2 3.14843 15.408 12.7949 3.95332 -3.2625 9.96296 -177 2 3.02181 15.7534 11.31 -3.03818 -3.40517 4.91625 -178 1 16.4251 15.6276 5.98753 2.75225 -2.61515 5.58966 -179 2 17.3447 15.6415 6.33695 -10.8386 4.94036 -7.12539 -180 2 16.2312 16.4474 5.48017 12.4296 -10.8984 6.26847 -181 1 5.80144 5.06794 11.7894 5.49032 -3.99323 1.93812 -182 2 5.42192 5.63452 12.4754 -2.65214 7.25607 -4.62846 -183 2 5.38258 4.20716 11.9011 -4.64894 2.39601 -1.00669 -184 1 15.1781 4.86184 0.728524 -4.34825 6.76152 14.6306 -185 2 15.2668 4.67158 1.68153 -8.60174 -1.32446 -9.75027 -186 2 14.3367 5.34751 19.2902 10.4034 -8.61994 -3.37533 -187 1 16.3306 16.3549 2.10387 -3.60874 -8.17165 19.4202 -188 2 16.1436 16.7757 2.96383 0.821724 -8.86269 -6.10473 -189 2 16.4161 17.1032 1.53428 7.22132 12.8567 -17.8694 -190 1 0.267773 4.86229 3.80408 10.7738 -14.2237 3.39069 -191 2 0.48911 5.8014 3.76313 1.80944 1.44211 5.87769 -192 2 1.0394 4.38382 4.18029 -13.1099 14.4171 -4.44332 -193 1 2.95694 15.0447 15.0954 -6.10325 -16.3486 9.96696 -194 2 2.71126 14.628 15.9563 6.59243 11.9398 -10.1751 -195 2 2.48371 15.8886 15.0723 0.827451 0.569437 4.39106 -196 1 1.13642 14.6155 9.54099 -48.9591 -6.29818 10.1377 -197 2 2.0574 14.6763 9.37448 31.1561 -9.052 1.81392 -198 2 0.917533 13.7788 10.0133 17.9146 13.2649 -10.59 -199 1 13.6267 16.618 11.5309 -14.0517 -2.94194 4.54584 -200 2 13.2284 17.3872 11.0909 1.36391 -4.96948 -3.72009 -201 2 13.0435 15.8681 11.2876 10.4622 6.11411 -5.34277 -202 1 4.69594 1.47637 0.748111 -12.1621 -0.739309 -0.414133 -203 2 4.0907 2.00679 0.20438 8.77888 0.173625 -0.66482 -204 2 4.10511 0.858084 1.19895 3.99089 -4.2391 -0.703649 -205 1 1.43799 18.5334 11.8677 4.48354 -19.5441 -2.70285 -206 2 1.28309 0.34807 12.6964 -2.38454 7.77338 6.6957 -207 2 1.65634 17.6099 12.1011 0.514199 12.3996 -0.852918 -208 1 11.5339 10.1172 4.0507 5.82948 9.6286 -18.4863 -209 2 11.2843 10.5321 3.18756 5.15824 -8.38498 16.2271 -210 2 12.5124 10.093 4.04255 -10.5657 0.881913 4.0585 -211 1 8.32129 12.1582 3.72502 1.53352 8.77417 8.44763 -212 2 9.09494 12.6645 4.01218 5.78128 -3.64141 -7.92941 -213 2 7.76311 12.2518 4.50437 -12.3191 -3.17133 -0.801295 -214 1 14.3738 4.02512 3.28302 13.4457 8.56362 13.3606 -215 2 15.0833 4.15474 3.94873 -8.39321 -4.82495 -4.85792 -216 2 13.6328 4.57269 3.59478 1.91801 -3.79011 -4.78214 -217 1 5.59001 1.69403 7.5104 -22.1497 -9.71937 -16.3739 -218 2 4.92965 1.04535 7.86703 17.0022 15.2682 -3.23125 -219 2 5.33019 1.76513 6.54994 10.6546 -4.2597 24.8978 -220 1 17.8762 1.11593 4.87562 6.9502 3.59021 1.61777 -221 2 18.6375 1.36949 4.33979 -2.23157 -1.53514 -7.48501 -222 2 17.9489 1.70322 5.63717 -7.55192 -1.12522 1.72169 -223 1 6.82082 9.41417 4.48467 7.28036 -1.61815 9.25922 -224 2 6.87733 9.61398 5.42883 -5.7945 0.587378 -0.0554941 -225 2 7.74179 9.22243 4.26363 -0.0627487 -3.5933 -6.80471 -226 1 2.67079 14.9403 1.9639 10.8093 -10.5544 22.1131 -227 2 3.25117 14.6591 2.70117 -12.0207 4.93014 -5.95014 -228 2 3.29732 15.1077 1.27121 3.13815 4.27624 -15.5237 -229 1 17.3067 12.913 13.1683 10.6019 -31.6629 4.62367 -230 2 16.4497 13.2737 13.3972 -3.78483 16.2252 -3.80314 -231 2 17.8834 13.5891 12.8053 -8.28955 15.595 1.58636 -232 1 14.9867 10.5664 1.39303 17.3246 -3.28745 6.09509 -233 2 15.5958 11.2392 1.752 -7.58668 -4.78908 -2.0363 -234 2 14.1528 11.003 1.29225 -13.717 8.26159 -1.38466 -235 1 5.69708 6.86241 4.54741 10.2551 2.99419 0.383868 -236 2 6.12873 7.74081 4.58523 -8.39477 -7.3362 -0.690872 -237 2 6.29159 6.23392 4.98874 0.140081 3.89587 3.34658 -238 1 8.04621 8.27418 10.2318 -1.25624 6.00125 -7.48209 -239 2 8.67166 8.94213 9.92965 6.80147 7.39227 7.14523 -240 2 7.62794 8.03247 9.40376 -7.32264 -11.607 2.12748 -241 1 13.4746 18.3625 5.78211 -13.502 7.51331 -2.26288 -242 2 12.7551 0.364455 5.61988 6.67968 -8.24018 -2.37745 -243 2 13.1168 17.8207 6.50434 6.50164 -0.829271 0.111391 -244 1 0.226362 2.58719 0.131375 -15.5932 24.0028 11.6326 -245 2 17.9693 2.93929 18.6394 3.5786 -16.3529 -5.12341 -246 2 0.708035 3.3711 0.44675 7.58398 -8.21165 -4.7522 -247 1 12.703 11.0237 9.75181 24.9284 -7.65781 8.94422 -248 2 11.7937 10.9936 9.46616 -11.7502 -8.38149 -1.23796 -249 2 12.9608 10.1029 9.99094 -10.5021 9.57622 -2.72207 -250 1 0.761974 12.2205 11.0816 -4.15363 -6.09516 -21.355 -251 2 18.4366 12.288 11.0674 3.38909 -0.754442 8.49561 -252 2 1.11175 12.4338 11.9478 -3.68194 5.91832 8.04416 -253 1 5.07253 7.26896 13.4467 3.90397 -0.0234352 3.77117 -254 2 5.61152 7.96046 13.0436 -1.11485 3.21213 -6.58832 -255 2 5.53238 7.13074 14.2827 -1.05457 -4.33313 3.81413 -256 1 1.23629 6.9109 11.8337 28.2892 12.95 23.6673 -257 2 0.51347 7.34016 11.3984 -13.736 7.24235 -8.87687 -258 2 1.75935 7.64669 12.2495 -13.9201 -17.9067 -15.9983 -259 1 15.4873 9.53008 12.3182 -0.383493 4.12812 -8.89679 -260 2 15.0655 10.399 12.2152 3.51435 -2.6855 7.45914 -261 2 15.2649 9.14784 13.1724 -1.90612 6.52608 2.19385 -262 1 16.6085 12.8345 5.46896 -3.55761 11.1023 -1.95777 -263 2 16.4419 13.7896 5.48874 0.313493 -0.193839 12.6146 -264 2 16.4475 12.6632 4.54137 -0.0496347 -14.7353 -8.15109 -265 1 6.20534 9.98194 0.0899104 18.0768 -8.37359 0.258846 -266 2 5.59572 10.4068 0.70246 -2.59094 3.74961 3.89273 -267 2 7.08249 9.9872 0.527613 -14.0474 2.02387 3.58276 -268 1 12.3397 6.07843 4.05984 1.81271 11.939 -8.21694 -269 2 12.2328 6.8085 3.41842 8.48996 -4.45606 3.14495 -270 2 11.4615 5.7138 4.10837 -10.8447 -6.35959 3.05037 -271 1 0.186481 12.7968 0.194157 8.45417 -0.362633 0.823389 -272 2 0.122538 13.4857 0.868002 -3.08717 1.48078 1.57348 -273 2 18.4164 13.184 18.057 -2.66731 -2.48236 -4.34426 -274 1 3.77162 18.5917 8.57827 -20.4554 1.45559 2.68175 -275 2 3.52322 17.9715 7.87805 6.33007 3.25639 -1.82086 -276 2 2.90938 0.367014 8.76804 7.74592 -0.0744794 5.639 -277 1 7.46409 17.2961 4.48316 -14.1198 -17.2275 8.02552 -278 2 7.88946 18.1398 4.59819 4.06261 16.9953 -5.43573 -279 2 7.32948 17.1504 3.54137 6.62361 8.1702 -3.03871 -280 1 9.24056 17.0796 12.2607 -1.29913 -0.841935 -6.42698 -281 2 9.19718 16.4258 11.5387 7.57092 0.344645 9.78983 -282 2 10.1052 16.9888 12.7016 -6.07497 2.05659 -6.06408 -283 1 13.326 12.928 7.96212 4.69357 25.6567 2.07593 -284 2 13.3763 12.2768 8.65803 -4.91574 -13.7878 2.50151 -285 2 13.7353 13.7181 8.35204 8.56042 -2.58857 -8.38859 -286 1 14.9538 2.97298 15.3382 -4.29462 -11.8182 -2.96981 -287 2 14.4639 2.15222 15.1644 -2.78402 11.1896 3.17375 -288 2 15.6292 2.97829 14.6488 1.75 3.70602 0.0805282 -289 1 9.85487 15.5414 16.9955 1.72232 -1.82893 -0.169847 -290 2 10.3837 14.7676 16.7382 -3.42626 -0.271454 1.71497 -291 2 9.29261 15.2923 17.7497 4.44449 2.55726 -1.27949 -292 1 11.3089 8.30526 16.5494 -6.04997 -6.2326 7.21044 -293 2 10.5881 7.89563 16.0543 2.01853 1.78394 -3.12513 -294 2 11.4835 7.65722 17.2517 2.74023 7.81545 -1.84368 -295 1 3.836 18.1836 16.7517 -7.13385 -19.1452 -23.0441 -296 2 4.27407 17.4593 17.223 1.84106 9.67264 7.83483 -297 2 3.88222 0.348533 17.2402 4.94653 11.64 14.7969 -298 1 2.18178 4.13609 8.93005 8.1701 -0.774865 9.73019 -299 2 3.0913 3.90524 8.75773 5.46766 -1.37508 -11.1104 -300 2 2.14869 4.01328 9.88774 -11.2166 4.12208 2.959 -301 1 9.87742 10.3647 9.70242 2.63105 14.1486 10.9213 -302 2 9.56679 11.2208 9.35298 -0.359428 -9.80694 -0.658425 -303 2 10.1334 10.5423 10.6269 -4.00587 -8.10964 -6.10976 -304 1 9.70429 0.823826 10.8553 -14.0108 4.16215 1.0267 -305 2 9.1278 18.77 11.1938 11.0832 -7.32823 7.11532 -306 2 9.14207 1.22722 10.1856 4.51331 8.02138 -6.87563 -307 1 9.20617 15.1402 10.2178 -11.609 -5.72992 -0.101326 -308 2 8.7465 15.767 9.6415 2.03963 4.50002 1.17892 -309 2 8.51696 14.4821 10.4282 6.2553 7.07807 -5.66984 -310 1 0.996164 9.40777 10.3157 -31.4617 35.4735 1.80375 -311 2 1.02993 10.3821 10.3914 -11.0752 -10.4846 4.01107 -312 2 1.89609 9.22017 10.2201 37.6387 -20.6805 -6.1303 -313 1 16.8786 4.85128 8.17759 -11.2506 16.3288 -5.48708 -314 2 16.2388 5.56314 8.38188 8.44756 -9.04525 0.78656 -315 2 16.9626 4.34108 8.98054 4.36808 -7.38136 2.74573 -316 1 14.6815 14.711 0.319263 14.4838 0.937126 -3.06264 -317 2 15.2721 14.9301 1.06391 -7.87321 4.75235 -6.44468 -318 2 13.8763 14.3724 0.714255 -5.91657 -4.41648 2.02008 -319 1 3.57415 11.0448 9.58418 2.91679 3.40936 2.58946 -320 2 3.69173 11.5263 10.4228 -3.34733 -6.02301 -1.37626 -321 2 3.07399 11.6483 9.00652 3.80152 0.245021 0.575116 -322 1 11.1013 10.8086 1.33492 -13.1151 -1.75228 0.351043 -323 2 11.4484 11.639 0.990604 2.68761 3.85867 -0.677593 -324 2 10.1644 10.7789 1.04773 13.6271 -2.80152 6.25142 -325 1 13.1828 7.11823 12.837 13.875 6.93007 -2.08809 -326 2 14.1546 7.00576 12.8731 -8.73741 -0.33434 -1.11439 -327 2 12.8407 6.21951 12.8306 -5.12621 -6.60309 0.0889066 -328 1 9.62491 1.88499 0.973614 -3.42399 -6.06492 -12.2684 -329 2 8.82152 1.4846 0.597998 2.34171 8.22807 3.07369 -330 2 10.1781 2.12743 0.21359 -0.384483 0.556473 6.61436 -331 1 10.6031 13.5334 4.66686 13.636 -3.8461 -1.22567 -332 2 11.4763 13.1252 4.55872 -4.58351 -5.15517 0.0143246 -333 2 10.7077 13.9241 5.53959 -7.66657 9.10334 4.04553 -334 1 14.3485 1.75735 10.9256 -1.10429 -17.7549 1.09656 -335 2 15.1861 1.44338 10.54 -2.80824 6.90847 2.1648 -336 2 14.3834 2.71874 10.9625 8.08978 3.11888 -5.0019 -337 1 14.6333 12.3432 11.6996 -1.39952 -9.16637 -24.1357 -338 2 15.3681 12.4502 11.0746 9.0546 4.11007 14.4837 -339 2 13.9355 12.122 11.0753 -11.0061 -2.1546 9.49113 -340 1 8.24004 5.06512 9.81661 -6.73852 -15.0928 -6.1646 -341 2 7.43321 5.24609 10.2868 -7.68507 10.8263 10.6715 -342 2 8.07004 4.14881 9.53169 13.9201 5.19095 -3.88371 -343 1 1.57861 16.855 18.3455 -3.6047 -18.8696 23.6299 -344 2 1.81992 17.2862 17.5419 10.6717 7.49965 -18.3027 -345 2 1.88846 15.9289 18.2434 -7.51751 10.9825 -1.36554 -346 1 1.48469 17.2399 15.3369 -30.5992 8.85894 1.58219 -347 2 1.52903 18.0991 15.7763 5.64601 2.15314 -3.36931 -348 2 0.515015 17.0623 15.2815 21.6878 -4.25813 -0.913042 -349 1 3.6961 5.66103 6.13276 1.27154 -4.68408 -0.174538 -350 2 3.02861 6.15393 6.634 5.94065 6.05513 -0.564102 -351 2 4.2706 6.29315 5.66099 -8.13711 -1.6893 2.05746 -352 1 12.3863 9.46112 14.1898 5.64676 -22.9439 1.72589 -353 2 12.6155 8.61212 13.7476 3.53191 14.2422 4.21489 -354 2 12.2183 9.16782 15.1036 -0.67103 6.17556 -4.58111 -355 1 4.03262 15.2884 6.88962 -6.96122 -2.16466 3.53978 -356 2 3.61008 16.076 6.4989 3.67472 -5.21865 6.04109 -357 2 4.98914 15.3892 6.82497 3.29203 7.08348 -5.36605 -358 1 0.610585 8.57451 14.9167 2.06858 8.16468 9.66942 -359 2 0.571526 9.5334 15.101 -0.509723 -6.74541 -4.80249 -360 2 1.24768 8.49017 14.2004 3.24343 3.39805 -1.00154 -361 1 12.9947 8.30502 10.3347 -2.10898 5.96297 -3.02925 -362 2 13.7245 7.79451 9.98073 4.34503 -3.62623 -11.9067 -363 2 13.0194 8.04092 11.2546 -7.35013 -0.655157 9.61409 -364 1 15.3021 7.68636 3.53463 20.0464 32.042 -6.64886 -365 2 14.6007 7.2355 3.06802 -7.18972 -17.1123 8.01585 -366 2 15.7144 7.29713 4.32433 -16.1768 -11.7678 -0.766084 -367 1 17.3034 6.68003 0.0493874 -1.84179 -13.5509 -2.88881 -368 2 16.9519 5.78424 0.161568 0.711034 6.10552 3.25575 -369 2 16.5083 7.2036 18.5276 -0.473138 7.46776 -7.84911 -370 1 8.84315 6.93181 7.84628 -0.943806 11.0529 -13.3888 -371 2 9.77771 7.20927 7.80441 -6.03996 -2.82935 4.46193 -372 2 8.74315 6.27043 8.54219 4.24547 -3.80386 5.92931 -373 1 12.3578 0.616451 1.20223 7.02437 -6.39463 -1.478 -374 2 13.2861 0.535705 1.47006 -5.02329 6.70293 3.96338 -375 2 12.2631 18.6802 0.444477 -1.70715 1.25222 -1.43865 -376 1 5.64724 15.135 14.5406 -0.604856 -11.7009 0.79572 -377 2 4.70142 15.1669 14.7844 5.92695 5.15448 -4.69419 -378 2 5.94602 16.0188 14.2721 -2.36621 0.047849 -2.09121 -379 1 3.86203 6.47491 1.73695 1.36817 -0.22553 5.39386 -380 2 3.46749 7.3178 1.48065 -2.80916 3.79134 -8.60259 -381 2 4.09027 6.61791 2.66801 -1.52617 -4.74348 -3.78665 -382 1 3.89615 11.6258 12.3135 -4.96985 -7.23752 -2.42851 -383 2 4.76636 11.9561 12.5635 2.33504 5.86151 0.242199 -384 2 3.23901 12.1927 12.7515 8.69891 -3.88643 -0.482475 -385 1 5.40213 3.8611 15.8693 10.8945 -12.2769 2.09816 -386 2 6.15363 3.21949 15.8699 -18.4435 12.0745 -5.1575 -387 2 5.79254 4.73962 15.8533 3.23601 3.32406 0.742539 -388 1 14.4255 10.2871 4.42158 -5.00773 -17.9107 13.5675 -389 2 14.5181 9.70279 5.20492 2.69814 10.8256 -8.91808 -390 2 14.7837 9.77905 3.68069 -0.206993 2.85241 0.289205 -391 1 7.87167 17.3723 9.20121 -10.8695 6.25183 -3.73994 -392 2 7.03582 17.6433 9.5986 1.28641 -7.15132 6.24862 -393 2 7.9635 17.9776 8.45108 8.3983 -5.79413 -1.77097 -394 1 4.52981 14.473 3.9851 -7.27149 14.4717 16.1092 -395 2 4.4292 15.3844 4.34508 5.86047 -13.4028 -12.5476 -396 2 4.51094 13.8931 4.76638 0.622359 -0.721789 -7.97238 -397 1 14.2548 7.40188 15.768 -9.88191 3.80355 1.83721 -398 2 15.2055 7.32768 15.6782 10.3356 -1.93634 -2.70959 -399 2 14.1214 7.72007 16.6658 2.42251 2.42868 0.921806 -400 1 2.92318 18.2319 1.90056 8.21916 -2.84793 -3.01579 -401 2 2.38261 17.6158 1.3774 3.82694 3.92633 -2.29165 -402 2 2.32657 18.895 2.2462 -10.4983 4.84254 7.82145 -403 1 7.9872 1.59624 4.55123 -13.2342 7.82044 -5.09514 -404 2 7.38456 2.15817 4.04087 -4.12207 -9.74777 1.09289 -405 2 8.829 1.94177 4.28864 19.9647 -0.586446 1.64736 -406 1 2.52886 14.1331 17.7106 9.56011 -8.28606 7.0204 -407 2 2.01365 13.3855 18.0679 -1.20108 10.5585 -3.23507 -408 2 3.45026 13.9294 17.9721 -7.58546 -2.42865 -2.00823 -409 1 0.784808 1.71729 13.877 -22.3729 3.14932 11.7627 -410 2 0.820241 1.39718 14.7912 6.0833 4.21121 -6.47959 -411 2 18.4913 1.99435 13.7832 17.5446 -4.15928 -6.69512 -412 1 4.49906 18.6473 13.9354 -18.7945 1.8826 8.61585 -413 2 5.41644 18.4141 14.0419 11.9469 -5.27484 -6.26214 -414 2 4.07897 18.3597 14.7657 2.79866 5.45516 -5.58976 -415 1 7.09283 0.599142 18.3486 34.6471 -4.12786 -6.63011 -416 2 7.39021 0.234617 17.4878 -9.84259 3.28252 9.67216 -417 2 6.14438 0.553251 18.3894 -16.3447 5.16139 0.014819 -418 1 16.0881 18.4309 14.0453 5.06229 7.716 24.0321 -419 2 15.2482 18.0804 13.8032 -16.2536 -8.6858 -12.6141 -420 2 15.9952 18.587 15.0073 9.58514 -0.127307 -10.5143 -421 1 10.0776 4.50678 16.2676 12.8821 37.0646 3.31891 -422 2 10.9819 4.89306 16.3611 -10.6263 -20.5161 -3.34059 -423 2 10.1424 3.55939 16.3223 6.24363 -16.5382 -1.58612 -424 1 15.8992 17.8398 4.41934 12.2004 7.51097 -4.98004 -425 2 16.3832 18.6941 4.42415 -3.71288 -10.9395 3.02327 -426 2 14.9903 18.0494 4.62819 -9.96916 6.21932 6.5896 -427 1 6.98832 17.3871 13.7576 13.6855 5.49553 14.8404 -428 2 7.37965 17.5993 14.631 -4.71479 -0.449691 -14.3122 -429 2 7.76575 17.2997 13.1656 -13.1106 -1.1113 5.84114 -430 1 13.2824 6.5097 6.67953 4.56939 11.9611 -5.54075 -431 2 14.0532 7.04843 6.47095 5.72005 -2.26771 11.4806 -432 2 12.9258 6.37058 5.8058 -10.6331 -8.36185 -8.97535 -433 1 7.75109 2.3756 9.23631 -5.33505 -3.40336 15.3372 -434 2 7.18759 2.24157 10.0186 8.87424 2.78019 0.355864 -435 2 7.20141 2.0575 8.52046 -4.61968 -0.366971 -12.063 -436 1 15.1734 14.8403 13.6669 0.441467 -1.73197 5.96822 -437 2 15.0738 15.2212 14.5455 0.591215 -4.0348 4.14746 -438 2 14.518 15.2716 13.122 -1.09719 2.73458 -8.10719 -439 1 9.35119 8.31644 3.739 2.66762 7.66889 5.69365 -440 2 10.15 8.71947 4.13947 -5.98752 -7.29531 -6.80605 -441 2 9.38201 7.35632 3.87197 4.69073 2.10751 1.74529 -442 1 17.751 13.5231 16.4139 1.76506 1.52762 0.696064 -443 2 16.8205 13.2419 16.3833 1.32585 7.25436 -2.93419 -444 2 17.8025 14.3962 15.9827 -4.54797 -4.37418 0.927992 -445 1 4.99908 10.6417 2.69781 -10.2301 11.821 9.59097 -446 2 5.61637 10.2237 3.29708 11.0389 -6.03173 2.08237 -447 2 4.70065 11.4181 3.20566 0.509198 -9.80178 -10.0294 -448 1 3.73671 8.33589 10.2301 0.811909 12.56 -11.1256 -449 2 3.79833 9.26935 9.95307 1.30999 -3.93497 -1.66187 -450 2 3.73931 8.38186 11.1831 0.045476 -4.76093 8.99044 -451 1 16.0469 7.05349 6.21752 -8.36922 7.98368 -7.54927 -452 2 16.8656 7.47651 6.4961 3.44749 0.07849 4.67395 -453 2 16.1438 6.1088 6.32704 6.52122 -4.4821 -3.05144 -454 1 15.1289 7.04368 9.08785 10.4694 9.8467 1.75835 -455 2 15.8264 7.38614 9.67453 -3.18259 -3.19274 -6.50653 -456 2 15.1274 7.66298 8.34243 -1.48772 -3.73631 0.00250057 -457 1 6.37899 13.0555 12.8241 7.15095 -9.93714 4.62427 -458 2 7.14263 12.6042 13.2293 -5.49135 0.351509 -10.6671 -459 2 6.23455 13.8287 13.3737 -7.10156 7.81238 6.40695 -460 1 12.1361 4.49173 13.0886 -33.3605 -9.49617 -7.12831 -461 2 12.0495 4.6518 14.0281 12.9755 3.95225 11.8447 -462 2 11.274 4.06082 12.879 23.5373 6.19102 -2.9945 -463 1 11.3516 8.18262 7.87035 -14.4325 7.02786 -3.11936 -464 2 12.0471 7.65769 7.46008 8.6713 -7.43794 3.47117 -465 2 11.5359 8.26397 8.81258 10.0684 -2.50636 2.15934 -466 1 17.1915 10.8124 7.44959 -16.1176 10.6393 13.8832 -467 2 17.9047 10.1798 7.28217 -0.931293 1.13858 -10.0543 -468 2 16.9855 11.3827 6.68215 10.1883 -6.89581 1.62445 -469 1 5.25104 18.1119 11.0466 -2.03712 6.82198 -5.53245 -470 2 4.55844 17.9395 11.7023 5.22213 1.54215 -0.259713 -471 2 4.79647 18.4173 10.2467 -3.05137 -7.80568 1.06144 -472 1 7.59144 17.5428 1.82585 2.02366 6.3387 -27.4892 -473 2 7.8094 16.7742 1.27336 1.17923 0.135637 10.7354 -474 2 7.55288 18.254 1.15356 -7.65387 -5.36774 12.2151 -475 1 1.92063 12.9184 13.6023 -9.91855 -8.75107 -5.23832 -476 2 1.37345 12.2779 14.0844 5.59931 4.65398 4.03533 -477 2 2.08932 13.6638 14.189 3.88592 4.92281 2.07481 -478 1 9.68002 6.79239 14.8375 -5.9785 1.55821 1.53848 -479 2 9.8605 5.87105 15.0454 -1.79232 -6.14635 7.43903 -480 2 10.0701 6.92553 13.9753 -0.129146 4.69231 -11.1498 -481 1 15.2463 4.32976 10.758 3.34542 15.1712 12.775 -482 2 16.1952 4.27653 10.855 10.1577 -17.3864 -7.84826 -483 2 15.0718 4.96713 11.4544 -13.5892 3.80238 -1.28771 -484 1 11.2223 6.14234 0.184515 14.935 15.986 0.702496 -485 2 11.3427 5.2537 -0.179589 -9.34658 -3.11564 3.17557 -486 2 10.3073 6.45674 18.8196 -5.33379 -13.1911 -7.29958 -487 1 0.101128 11.3538 15.0994 -20.5112 19.1646 -16.3994 -488 2 18.0631 11.5965 14.4157 17.8209 -6.40715 11.0417 -489 2 18.7281 12.1498 15.6639 -2.69532 -11.5931 2.167 -490 1 7.07341 9.21118 7.26397 13.6545 -4.38359 1.14819 -491 2 6.46912 8.52168 7.54812 -6.91606 -6.22713 3.38737 -492 2 7.94495 8.78194 7.35853 -7.81842 8.24868 -3.32543 -493 1 18.379 15.4045 12.3485 -3.73833 -6.55761 4.14497 -494 2 0.693581 15.4288 12.2501 6.70794 3.85833 -5.56408 -495 2 17.998 15.8269 11.5664 0.97425 0.444703 -1.66759 -496 1 16.5516 4.36462 5.23826 -5.38189 5.67955 -17.8631 -497 2 16.655 4.28498 6.19256 13.2509 -4.37544 3.08954 -498 2 17.3965 4.59413 4.7818 -8.47419 -6.89051 15.5314 -499 1 17.7443 3.09877 10.7286 3.04827 -10.7181 -6.87848 -500 2 0.0283995 3.26624 10.9392 2.02267 5.05617 3.97045 -501 2 17.7464 2.2027 10.3321 -6.96828 10.7891 3.50943 -502 1 12.2779 0.0212452 10.1338 -0.475788 -3.12763 3.03365 -503 2 11.45 0.377358 10.5143 6.17492 -0.459139 -6.32122 -504 2 12.9469 0.721114 10.1609 -4.48032 5.31969 3.75096 -505 1 10.3747 9.79435 12.3975 0.995366 2.64477 2.84838 -506 2 11.0916 9.86004 13.0462 0.88472 -0.940912 -1.26785 -507 2 10.2331 8.84374 12.2815 -0.892889 0.226532 -0.81052 -508 1 0.549483 2.84316 7.02126 -1.47246 -21.9217 -16.5589 -509 2 0.577314 3.5439 7.66737 3.67317 4.63089 12.4819 -510 2 0.765862 2.00117 7.45653 1.04632 13.6877 4.9994 -511 1 0.405258 15.2829 6.93023 -2.49907 -5.43649 4.98244 -512 2 0.538371 14.8975 7.8327 2.16571 9.44122 -16.3162 -513 2 0.725684 14.6278 6.28848 -1.93707 -3.30699 10.9749 -514 1 17.0129 7.01771 15.2646 8.6122 -7.5627 -5.22629 -515 2 17.8138 7.53109 15.1273 -3.20292 15.4854 -2.58719 -516 2 17.4051 6.15342 15.4314 -10.2841 -6.73634 6.86556 -517 1 9.05466 12.4444 8.11302 13.0521 -10.4864 -20.5516 -518 2 9.3276 11.8473 7.39447 15.1337 1.48797 7.8591 -519 2 8.12011 12.397 7.99286 -24.7878 10.4099 9.23055 -520 1 1.26093 1.88381 3.01396 9.71768 11.5305 -0.318626 -521 2 0.781341 2.25664 2.27301 -4.68813 -2.91629 -4.97973 -522 2 1.78505 2.63319 3.35529 -3.04295 -14.2735 3.58948 -523 1 4.11799 15.1078 9.73252 4.576 2.76804 -1.92408 -524 2 4.09335 15.377 8.80945 -5.53143 0.588802 -2.3225 -525 2 5.02333 14.7824 9.83323 -1.70794 -2.53339 7.76874 -526 1 7.21252 2.18262 14.5895 -3.17269 -14.8219 8.52343 -527 2 7.02371 1.74902 13.748 4.05246 3.09826 3.19753 -528 2 7.71073 2.97164 14.4061 4.58862 11.2949 -7.92291 -529 1 18.5773 14.6793 2.1781 -14.8885 -13.9434 -3.10254 -530 2 0.806981 15.0773 2.13409 4.68638 9.16713 1.06255 -531 2 17.8879 15.3584 2.08187 6.00104 3.32119 3.09374 -532 1 9.95988 2.75708 12.9307 -3.19888 4.8993 -0.068744 -533 2 9.83509 2.14797 12.1955 3.80206 -8.82317 -3.94881 -534 2 9.20326 3.3528 12.8696 -1.08171 3.11286 5.06453 -535 1 2.85334 8.94069 13.0534 -9.07349 -10.7547 -1.24525 -536 2 3.30632 9.75091 12.8027 2.98523 12.1914 -0.768468 -537 2 3.53212 8.32042 13.3313 9.61222 -2.32206 4.81477 -538 1 3.22451 8.40753 3.67121 22.1548 25.1655 0.793749 -539 2 3.78763 9.07745 3.2153 -17.2399 -11.2925 0.757254 -540 2 3.40605 8.58793 4.60238 -4.67213 -6.04062 1.9181 -541 1 5.62069 7.18926 8.53747 6.69229 -2.05947 9.74796 -542 2 5.86853 6.28591 8.76536 -0.744086 -3.6627 -12.9201 -543 2 5.09246 7.43537 9.3012 -7.69944 9.66912 -1.05292 -544 1 14.8771 1.33506 1.99369 -4.37531 -14.3045 14.6387 -545 2 14.6174 2.14132 2.47402 3.99094 2.69357 -12.1219 -546 2 15.1274 1.48157 1.08098 3.94771 15.4277 -5.2716 -547 1 8.29964 15.2018 0.824762 -0.280237 2.12341 -18.5848 -548 2 9.0741 15.0554 1.38374 0.657448 -4.01578 8.69554 -549 2 7.56069 14.656 1.13255 5.04945 -5.16558 7.75703 -550 1 15.6052 1.34643 7.22407 3.75056 4.73875 0.699016 -551 2 15.0587 0.773182 6.67423 -5.35564 1.12746 0.995868 -552 2 15.1053 2.16848 7.37587 -1.8024 -6.33902 1.47434 -553 1 4.99443 13.0609 18.5093 -5.69789 -0.343563 -13.2097 -554 2 5.39232 13.2306 0.720212 5.08054 -1.92613 6.3414 -555 2 5.7137 13.1567 17.8693 -5.50653 4.49423 4.11534 -556 1 15.3782 8.49607 18.1492 -5.08872 -0.806473 3.30258 -557 2 15.7135 9.0139 17.4023 0.0404722 4.09908 2.1153 -558 2 15.1698 9.14329 0.203973 4.81283 -1.94937 -4.21801 -559 1 12.0917 3.05456 18.3485 5.25344 -19.9367 5.19329 -560 2 12.3328 2.56101 0.492796 -7.10973 11.5886 11.7441 -561 2 12.4167 2.41374 17.7115 -1.86526 8.77132 -18.5664 -562 1 13.1991 12.6728 5.17615 -0.124316 -0.0560055 4.18836 -563 2 13.6438 11.8331 5.03438 2.42254 -3.05364 -13.3032 -564 2 13.4089 12.8359 6.10375 -5.84435 4.2533 1.84347 -565 1 6.03469 7.1207 0.0631469 12.4635 -7.18562 -1.52206 -566 2 5.88549 8.01359 19.0305 -4.09863 7.65543 -4.79966 -567 2 5.21365 6.64029 0.190066 -5.29753 1.61074 5.21091 -568 1 17.6997 15.9613 14.987 30.7149 -12.4194 32.4504 -569 2 16.8862 16.4214 15.1458 -18.1669 6.52853 -13.961 -570 2 17.8877 15.7083 14.0822 -14.2113 6.66636 -19.3843 -571 1 13.1806 0.977208 16.5993 3.21446 -7.78263 -3.05852 -572 2 14.1069 0.725878 16.7441 -1.84519 3.55213 2.46319 -573 2 12.7536 0.148831 16.339 0.610986 0.436683 6.04854 -574 1 11.0624 14.5912 7.28204 -11.2181 -3.76258 -2.73638 -575 2 10.3867 13.9846 7.62705 2.11873 3.9908 3.08505 -576 2 11.9143 14.2091 7.50586 0.261112 -7.43153 0.664812 -577 1 17.506 8.58052 2.09005 -0.444247 -11.7988 -12.468 -578 2 16.6642 8.31502 2.4773 -2.50704 5.84538 6.9832 -579 2 17.563 7.99026 1.31874 6.86903 3.37396 8.78538 -580 1 12.3502 7.95652 1.98027 -3.36099 -5.49894 -2.13311 -581 2 11.9195 8.80992 1.98547 0.506131 9.65618 1.3531 -582 2 11.9377 7.50693 1.23044 6.6222 -7.49408 4.60604 -583 1 11.9327 14.6311 10.3511 -13.8226 21.3891 7.58711 -584 2 12.0851 13.8189 9.91206 10.3006 -23.5502 -10.4516 -585 2 11.0014 14.8158 10.1424 3.95037 3.15478 8.54077 -586 1 6.86541 7.01247 15.582 10.3214 -0.24422 -5.9518 -587 2 7.78025 7.06796 15.2658 -3.95377 -6.01896 -2.62563 -588 2 6.83046 7.729 16.2102 -7.67029 5.21932 8.6005 -589 1 8.00165 4.68416 13.4443 -21.8863 -22.7248 -23.0503 -590 2 7.36443 4.84116 12.7101 7.64348 -4.39085 15.7408 -591 2 8.44337 5.50298 13.5544 13.6077 24.8283 3.95349 -592 1 13.4082 12.1692 14.291 7.74384 0.583631 -6.74495 -593 2 13.3391 11.2097 14.1788 -8.03609 -0.555633 4.00216 -594 2 13.8852 12.4587 13.496 -2.17037 2.06617 1.19415 -595 1 14.784 9.43826 7.28323 -11.1269 12.8929 16.9671 -596 2 15.4951 10.0466 7.55684 1.33033 -10.8665 -8.82607 -597 2 14.017 9.71262 7.81429 7.01149 -4.68319 -9.50468 -598 1 12.6837 17.0142 3.10751 10.9269 -13.9095 9.51878 -599 2 12.9708 17.2813 3.99359 -6.48615 4.53386 -3.20168 -600 2 12.1282 17.7068 2.75827 -7.19321 10.5694 -1.73823 -601 1 1.13983 7.14905 17.429 -19.8537 -0.642492 -7.24746 -602 2 0.229092 6.89189 17.6928 9.24629 12.0374 -0.554306 -603 2 1.04788 7.63326 16.5858 1.73105 -6.23108 5.83737 -604 1 12.8283 5.10796 15.6891 -3.1105 -1.51238 -5.72518 -605 2 13.5351 4.46064 15.5231 -0.330328 2.49365 6.49287 -606 2 13.2544 5.98171 15.6287 1.13166 -7.6156 1.26811 -607 1 2.48175 3.38612 5.07416 -11.4746 -6.3359 16.597 -608 2 1.87059 3.13723 5.824 15.2627 10.0051 -19.3068 -609 2 3.07561 4.08306 5.41325 -9.83136 -1.83582 -2.79497 -610 1 8.32062 11.2204 13.4908 14.3326 -12.3724 2.23055 -611 2 8.41586 10.9603 14.3918 -15.5351 3.38632 26.9235 -612 2 9.1195 10.7822 13.1796 -2.73354 4.12568 -26.6086 -613 1 12.9112 1.40899 13.3219 3.38587 -22.7152 11.6955 -614 2 13.5257 1.21801 12.5994 -2.66679 10.6744 -3.40434 -615 2 12.4724 2.23119 13.1327 -1.22779 13.5514 -6.35015 -616 1 6.39925 13.6301 2.14388 13.7527 -0.778699 -6.56015 -617 2 5.84347 14.0897 2.78318 -1.88549 -3.79567 9.96763 -618 2 7.03431 13.0755 2.63977 -7.58465 4.89894 -0.0461429 -619 1 15.9327 6.56061 12.7538 -0.9836 2.19135 -10.6596 -620 2 16.5146 6.98287 12.103 -5.34808 0.40017 1.48081 -621 2 16.2873 6.8165 13.6112 3.99792 -3.90075 7.11277 -622 1 16.8306 0.705066 9.59578 -7.6122 -1.79623 -7.44488 -623 2 16.785 18.3903 9.75048 3.18156 2.06447 -0.865929 -624 2 16.3719 0.843651 8.74144 5.4764 0.262409 5.10626 -625 1 6.12658 11.6826 8.3633 -3.5227 -13.2845 -7.84739 -626 2 5.19255 11.5559 8.64231 15.2704 -3.4985 -2.63712 -627 2 6.45331 10.8168 8.01189 -8.18375 16.1965 9.35276 -628 1 2.85137 8.68091 0.385463 -5.58051 9.89965 12.0536 -629 2 2.19225 8.31695 18.4611 -2.16592 -25.8024 -20.6889 -630 2 2.2971 9.35613 0.77772 10.4924 10.4953 14.3564 -631 1 10.1291 10.4583 6.52809 -2.44089 1.08082 5.72444 -632 2 10.551 9.78353 7.0828 -0.111445 0.581803 -4.14441 -633 2 10.6952 10.5682 5.75546 0.540532 -2.90301 -3.90698 -634 1 6.75412 15.726 6.57209 -8.13971 -2.30487 -2.02419 -635 2 7.24364 15.9641 7.36655 2.15693 7.18823 -0.87292 -636 2 6.8879 16.4298 5.90744 8.86888 -7.67267 7.00242 -637 1 6.43944 13.0908 5.62507 5.5957 4.80241 6.78236 -638 2 6.68766 13.9873 5.91055 -1.86537 -6.12454 -2.89892 -639 2 6.02344 12.6885 6.39583 0.545895 -2.8305 -0.33431 -640 1 16.7919 12.5477 9.81186 8.33998 7.78307 -15.4118 -641 2 16.959 11.947 9.07064 -2.3739 -7.40637 3.16023 -642 2 17.0566 13.4004 9.43565 -5.48117 -2.43007 10.0621 -643 1 6.08508 2.94496 2.79534 5.32525 -4.78467 20.7365 -644 2 6.22401 3.88181 2.60268 1.06349 -0.160394 -8.38338 -645 2 5.80007 2.47136 2.00522 -4.08992 3.93243 -8.80646 -646 1 10.8869 3.24711 3.28239 -4.40001 1.54122 -3.81905 -647 2 10.3919 4.04182 3.50512 -0.182415 -1.04618 4.274 -648 2 10.507 2.97693 2.43998 1.37333 -6.80979 -0.861155 -ITEM: TIMESTEP -40 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.77679 7.00681 17.9176 19.5781 -11.4355 -6.13067 -2 2 7.88289 7.04978 18.2154 -24.3238 4.20085 7.9494 -3 2 8.82569 6.20257 17.3924 1.80136 1.41546 -3.93969 -4 1 18.6608 8.28849 6.81179 -5.26854 6.47195 -37.0065 -5 2 0.259818 8.10211 5.87223 -9.20216 6.37217 14.1473 -6 2 0.533966 7.65898 7.28863 11.4703 -14.4857 21.9358 -7 1 8.44459 18.6539 6.84319 -15.0888 3.44445 3.75329 -8 2 9.31627 0.207433 6.52222 15.1831 4.47029 -4.67038 -9 2 7.87035 0.688968 6.45696 3.7806 -3.44044 1.26969 -10 1 6.57294 1.78151 11.6706 -30.0599 9.45416 18.0529 -11 2 5.79693 2.24632 12.0928 24.7239 -13.8096 -10.3139 -12 2 6.23894 0.879353 11.5248 3.88204 4.12095 -2.29502 -13 1 7.0611 5.68864 2.39703 8.93877 -14.6422 -9.86735 -14 2 6.49127 6.20844 2.93802 -15.3109 10.2002 23.1803 -15 2 6.88849 6.05122 1.53455 1.63853 6.11013 -15.8751 -16 1 16.2018 10.2111 16.0976 42.0151 -2.30245 8.02011 -17 2 17.1767 10.3828 16.1846 -31.1897 -9.90141 -8.38467 -18 2 15.8087 11.0308 16.3852 -12.3763 9.98735 1.02793 -19 1 10.6387 14.9527 2.33657 9.03987 18.5511 -2.17595 -20 2 10.545 14.5243 3.1949 1.96881 -4.62445 -0.461144 -21 2 11.2262 15.72 2.53493 -10.4825 -13.512 -5.5858 -22 1 17.1607 8.25027 10.5569 -10.4361 3.90862 15.3578 -23 2 16.8456 8.92829 11.1924 -0.168965 -8.85021 -9.39988 -24 2 17.9277 8.63713 10.1294 7.74511 3.00226 -1.55375 -25 1 14.7566 15.8542 16.4215 -9.50848 16.8449 -9.38304 -26 2 13.8265 16.1715 16.4278 14.8795 -5.02546 -3.6071 -27 2 14.9162 15.569 17.3232 -2.48975 -11.4773 7.52297 -28 1 12.1331 13.4103 0.48985 -10.556 -4.43922 -13.5861 -29 2 11.9475 13.3795 18.1761 8.0664 -0.863413 7.07636 -30 2 11.3865 13.8946 0.862316 6.65844 3.98247 10.4433 -31 1 9.29843 5.44761 4.00486 3.37284 8.34248 -28.0116 -32 2 8.80378 5.24143 4.78809 -8.97197 -9.15203 12.3932 -33 2 8.61542 5.51114 3.30134 8.62356 -3.76178 8.99247 -34 1 1.79678 4.17189 11.6321 9.86643 -30.5991 16.8051 -35 2 1.62878 5.09135 11.8205 -3.04918 18.6361 6.49963 -36 2 2.25792 3.77365 12.4221 -11.5809 11.2089 -24.12 -37 1 2.02425 6.80455 8.32417 0.209126 8.78432 0.0974623 -38 2 2.41895 7.33028 9.04952 -2.4595 -11.9319 -6.9206 -39 2 1.91003 5.89259 8.64365 4.06316 7.1017 -1.03524 -40 1 5.41039 4.42866 7.97545 15.1976 -3.31539 14.1613 -41 2 5.46063 3.46886 7.81834 -3.32316 3.28084 -1.43066 -42 2 4.8072 4.83488 7.36206 -13.6118 -1.04066 -17.9483 -43 1 3.27942 2.94296 17.507 14.649 -12.38 -13.2068 -44 2 4.01307 3.22765 16.9192 -12.2988 4.29907 8.19647 -45 2 2.92414 3.72569 17.9407 -4.7152 6.06254 1.98711 -46 1 7.44402 5.32718 6.09908 -2.23439 -3.56175 -18.7368 -47 2 8.08992 5.98284 6.3762 -3.15187 6.11466 20.9447 -48 2 6.88688 5.06352 6.84221 3.51936 -1.39652 7.32666 -49 1 9.78623 6.99393 11.9838 -8.59529 -1.09594 -12.3674 -50 2 10.3445 6.45759 11.4052 1.55365 1.23763 7.43723 -51 2 9.00985 7.18223 11.4209 7.62587 2.79809 7.26056 -52 1 14.0725 3.61727 8.08367 12.8617 -8.18347 36.7285 -53 2 14.0228 4.31343 7.45005 -3.4794 19.1063 -13.5046 -54 2 14.4179 4.02628 8.91908 -9.29791 -10.4076 -21.8094 -55 1 4.59231 17.2384 3.97449 0.493238 3.33808 0.649061 -56 2 5.51414 17.4776 4.03994 12.0557 0.622386 5.90157 -57 2 4.23063 17.8039 3.28947 -7.41249 -4.06804 -9.31956 -58 1 16.4721 16.5989 10.1846 -15.657 14.3962 29.6607 -59 2 15.672 16.8273 10.736 23.5631 -12.0212 -18.4682 -60 2 16.1719 15.9965 9.50314 -9.75188 -3.46964 -7.56259 -61 1 1.98052 4.85246 0.373619 -1.44601 4.98585 -7.77412 -62 2 2.7262 5.17853 0.894803 -2.15831 4.7879 6.78517 -63 2 1.59165 5.65237 -0.0264377 4.8265 -6.05414 -1.09652 -64 1 11.6431 13.3034 16.3099 -7.83069 14.4437 11.7005 -65 2 11.0472 12.5464 16.386 4.77345 -10.1552 -4.34879 -66 2 12.2516 13.1635 15.5747 -3.53477 -7.02177 -5.05796 -67 1 10.1531 11.0326 16.9094 -23.9188 11.6521 -2.01913 -68 2 10.5087 10.1543 16.8125 9.70699 -14.9542 1.17008 -69 2 9.18648 10.9213 16.8155 11.1855 0.742098 0.22461 -70 1 11.7413 17.4552 13.4621 -1.23374 28.315 3.5075 -71 2 12.4767 17.2116 12.8888 0.8966 -9.51431 -5.30227 -72 2 11.7922 18.439 13.4864 2.17346 -17.034 -0.823798 -73 1 6.40572 9.32656 12.214 8.55802 19.8904 20.5686 -74 2 6.90308 8.91303 11.5283 8.82473 -10.1612 -21.9185 -75 2 7.05175 9.94906 12.6124 -18.2049 -7.77814 -0.199089 -76 1 16.2334 12.8098 2.68826 14.0272 -12.5996 -1.63763 -77 2 17.097 13.226 2.50419 -12.4159 2.28924 0.929092 -78 2 15.5495 13.4898 2.7216 0.770652 8.50493 2.13384 -79 1 0.665645 12.593 5.91595 32.2246 4.40393 3.59492 -80 2 0.90587 12.5095 4.99041 5.40697 -3.98614 -5.66175 -81 2 18.3758 12.6087 5.91046 -34.4951 5.63016 -3.48792 -82 1 5.23151 16.431 18.4431 -16.7943 8.81872 -4.95242 -83 2 5.79594 15.7593 18.0508 10.3373 -8.32481 3.89376 -84 2 5.47944 16.6222 0.707356 8.36178 -5.19521 1.40492 -85 1 0.571414 7.67431 4.12619 2.94709 1.59491 -2.60127 -86 2 18.6158 8.07004 3.46977 2.09916 -2.88444 -0.00351913 -87 2 1.46322 7.94524 3.84829 -2.55586 0.342718 0.201417 -88 1 3.11705 8.93424 6.4998 54.1901 -7.8337 2.25484 -89 2 3.7667 8.5317 7.12157 -13.167 10.549 -15.4875 -90 2 2.28764 8.76575 6.88741 -36.769 -1.96533 12.6863 -91 1 7.28047 10.3297 16.2671 12.2744 -1.5589 -10.8048 -92 2 6.65751 10.5384 15.5688 -5.93087 0.719661 3.96859 -93 2 6.78418 10.1979 17.0822 -4.65586 3.14184 2.44827 -94 1 11.1311 1.01006 5.00872 -4.59838 3.25637 13.1063 -95 2 11.104 1.87564 4.56859 3.00456 -5.57579 -4.19999 -96 2 10.7195 0.375584 4.41788 -1.87117 -0.379426 -13.1931 -97 1 4.37947 2.77237 13.219 1.2209 -0.528365 -1.66794 -98 2 4.72737 3.08878 14.0495 2.85744 14.0767 5.60955 -99 2 4.20383 1.85536 13.4394 -3.83295 -12.6961 -6.71285 -100 1 8.38383 10.1509 1.80871 -12.6182 20.2791 -9.41543 -101 2 8.178 10.838 2.47049 7.2019 -6.44506 -5.42193 -102 2 8.73482 9.42727 2.30684 9.9898 -17.6863 11.9989 -103 1 10.4319 1.72481 15.5562 12.4011 -4.85254 7.43664 -104 2 11.3895 1.56158 15.4091 -17.4954 3.73262 -0.131687 -105 2 10.062 2.13812 14.7716 6.37582 -0.463351 -11.2945 -106 1 2.70803 12.8564 7.7877 0.947466 12.6679 0.63847 -107 2 3.18684 13.6562 7.51328 0.350127 -6.04869 0.642024 -108 2 1.99719 12.778 7.13709 0.576803 -6.26493 0.417134 -109 1 3.70343 11.6943 5.19413 20.2082 20.004 0.0632986 -110 2 3.58824 10.8286 5.55511 -6.2763 -16.1433 9.0068 -111 2 3.08304 11.8089 4.48497 -14.3756 -1.22762 -7.56914 -112 1 6.79775 14.44 16.9261 12.4025 3.68508 -3.36544 -113 2 7.76361 14.3574 16.912 -9.58328 3.53086 0.838276 -114 2 6.54478 14.7426 16.0399 -3.94857 -4.38541 1.40645 -115 1 14.2011 14.5459 3.3522 -3.08566 -2.84615 -1.00806 -116 2 13.6596 15.3308 3.14384 3.83224 -9.07839 4.89455 -117 2 13.7292 13.9763 3.99269 1.14293 11.3016 -6.48612 -118 1 8.39096 18.1361 16.0337 -32.316 13.1552 1.22555 -119 2 8.83502 17.3455 16.3332 22.4875 -6.85104 -0.859562 -120 2 8.9267 0.219511 15.6905 18.196 -4.39201 7.01778 -121 1 4.72714 1.63535 4.92703 -26.6842 -20.3158 26.1173 -122 2 3.8064 1.92851 4.99525 4.72714 3.40068 -1.69015 -123 2 5.07003 2.08002 4.18139 17.9323 21.4409 -28.6349 -124 1 14.9964 12.7123 16.4352 -4.22015 -14.1687 -30.4934 -125 2 14.5029 13.21 17.0522 -6.30453 18.4993 32.9687 -126 2 14.3164 12.5754 15.7407 23.1427 -3.84454 1.0347 -127 1 15.7385 18.4508 16.8675 -13.9243 -22.2803 -23.7862 -128 2 16.4074 18.4637 17.529 20.9098 4.79862 21.1737 -129 2 15.5806 17.4953 16.7298 -7.09236 11.271 1.12369 -130 1 1.21817 1.19055 16.5653 11.7565 -7.97186 -17.2906 -131 2 1.96844 1.77109 16.7379 1.96571 4.11248 6.40071 -132 2 0.658106 1.26508 17.3256 -9.62795 7.29392 16.1709 -133 1 18.134 4.50826 15.9251 -3.15057 6.2034 16.9599 -134 2 18.3539 4.06683 15.1192 3.29697 -9.24478 -15.9855 -135 2 0.215105 4.3469 16.5346 0.451532 1.5183 -0.00159427 -136 1 12.2559 16.9635 16.13 9.81693 16.417 -30.969 -137 2 11.5335 16.7255 16.6761 -27.6315 -15.1383 17.2649 -138 2 11.8852 17.008 15.2138 11.4543 -2.176 15.2032 -139 1 16.0072 2.53826 18.0715 2.86853 -7.51147 -8.26075 -140 2 15.4847 3.23875 18.4474 -1.55266 16.6686 8.62869 -141 2 15.8031 2.59593 17.1292 0.710765 -2.58084 -2.04371 -142 1 6.70782 13.8427 10.2201 -0.679857 -3.70625 -19.7607 -143 2 6.50134 13.5235 11.1067 -0.321862 -5.5215 0.0793921 -144 2 6.59662 13.1168 9.5703 -2.40279 4.60459 14.5526 -145 1 10.136 18.3381 2.74267 -18.0567 -22.0341 20.6824 -146 2 10.1719 0.451126 2.17508 1.85432 15.9621 -15.8725 -147 2 9.21984 17.9907 2.65838 20.6262 7.0183 -5.07627 -148 1 3.02443 17.7208 6.1026 17.1013 10.0229 -4.66436 -149 2 2.15568 17.711 5.71196 -13.0363 -3.14036 -7.80794 -150 2 3.59824 17.9918 5.35649 -4.18715 -9.59785 14.6662 -151 1 12.576 16.8948 8.01086 19.6337 5.92584 -6.52436 -152 2 11.8143 16.3513 7.79321 -8.3204 -4.9503 8.18666 -153 2 12.4158 17.4227 8.81259 -8.93553 -1.00079 -7.85288 -154 1 14.8883 15.2954 8.22088 18.3997 -23.9506 8.44323 -155 2 14.185 15.9366 8.136 -10.7922 9.32905 -8.87486 -156 2 15.3949 15.2296 7.38647 -11.857 13.9652 6.76292 -157 1 17.682 18.2494 0.348905 -7.91474 13.422 2.87656 -158 2 18.5411 17.7865 0.321045 -1.05993 10.3639 -2.93184 -159 2 17.7527 0.554981 0.612143 9.7328 -21.6142 -4.56589 -160 1 0.864553 10.4271 1.36107 38.8853 37.5027 -14.379 -161 2 0.108953 9.99831 1.68821 -41.9718 -23.1906 9.82059 -162 2 0.582253 11.2112 0.83245 0.481516 -18.0373 9.72219 -163 1 1.69239 12.2275 3.35367 -4.8948 -13.153 3.57872 -164 2 1.37753 11.4769 2.79371 7.82838 19.3971 -0.83705 -165 2 1.72119 13.0511 2.84994 -1.71551 -5.72989 -9.02345 -166 1 0.593488 17.2339 4.88925 5.54216 -9.27995 13.1842 -167 2 18.6577 17.9974 4.73698 -0.720643 -6.26101 15.0882 -168 2 0.46443 16.7935 5.76992 -5.72363 16.5902 -22.8723 -169 1 1.11371 0.949119 9.43078 -14.7072 -12.8067 -15.4602 -170 2 1.29442 0.455313 10.245 -0.545661 8.99323 2.98013 -171 2 0.250893 0.599212 9.12975 16.3522 9.05079 5.79158 -172 1 16.7438 2.34594 13.2927 -5.57812 -16.9062 26.8121 -173 2 16.8801 2.6271 12.4058 4.66444 4.54161 -27.0891 -174 2 16.4868 1.39796 13.2842 6.06262 14.3342 0.102967 -175 1 2.62374 15.8311 12.1325 -18.0747 14.04 -25.4855 -176 2 3.15014 15.3809 12.7666 13.9506 -11.3972 18.0386 -177 2 3.07511 15.7224 11.2774 1.07994 -2.68321 4.96368 -178 1 16.4243 15.6576 6.03755 15.9104 -4.34147 -2.36376 -179 2 17.3476 15.7161 6.33483 -8.235 -6.85341 4.18965 -180 2 16.3427 16.413 5.44101 -7.92512 0.157724 -1.18513 -181 1 5.79129 5.09168 11.8004 -4.72983 -0.0241771 3.34223 -182 2 5.24592 5.67928 12.3598 8.87085 -1.40185 -4.45321 -183 2 5.33436 4.24005 11.794 -1.89173 5.24027 0.81451 -184 1 15.1611 4.86757 0.757741 -10.8083 7.02962 -6.60621 -185 2 15.185 4.56786 1.66832 -2.59424 -2.50065 9.27943 -186 2 14.3347 5.37902 0.687967 11.9305 -6.73266 -3.44958 -187 1 16.3215 16.3801 2.08305 3.66808 -22.0917 28.3334 -188 2 16.2883 16.7145 3.0131 -8.2177 -1.24054 -23.9705 -189 2 16.5228 17.1161 1.52724 6.03518 21.1991 -10.8898 -190 1 0.258418 4.84833 3.80491 9.83943 -33.1452 17.0376 -191 2 0.435143 5.7654 3.92096 2.60191 31.4745 -0.643169 -192 2 0.932226 4.39489 4.35318 -12.3014 6.6918 -13.6862 -193 1 2.96829 15.0617 15.1396 -6.44278 -4.84309 -5.22724 -194 2 2.79942 14.7982 16.0602 -0.108783 -2.99279 -5.19286 -195 2 2.41643 15.8476 15.0194 7.7594 2.37019 3.88633 -196 1 1.13965 14.6405 9.53256 -35.9747 -40.3241 22.6064 -197 2 2.06314 14.7027 9.49112 43.1319 12.9068 -8.07313 -198 2 1.0594 13.7772 10.0119 -9.44904 20.5678 -15.2205 -199 1 13.5675 16.5961 11.5382 5.93785 -23.7105 -2.52771 -200 2 13.3768 17.2545 10.8786 -7.41053 16.3631 -3.48345 -201 2 13.1856 15.7884 11.1314 1.00946 8.65797 10.7521 -202 1 4.66618 1.4643 0.77663 11.7421 5.19522 -12.5382 -203 2 4.19094 2.00712 0.127209 -4.75679 -3.07286 5.52347 -204 2 4.08138 0.751582 1.04859 -6.60629 -1.36494 5.43578 -205 1 1.44472 18.5589 11.8552 5.89014 -29.5111 2.70443 -206 2 1.28184 0.411827 12.6654 0.0657759 4.1157 4.72514 -207 2 1.66959 17.6355 12.1243 -0.811151 21.0135 -2.36357 -208 1 11.5239 10.1243 4.0099 -6.2394 6.26334 5.03821 -209 2 11.225 10.535 3.18075 6.07738 -4.97061 3.39644 -210 2 12.4891 10.1836 4.01184 1.61922 -2.52467 0.807021 -211 1 8.27885 12.1614 3.71144 8.13123 -6.41358 -26.5436 -212 2 9.10665 12.5897 3.97429 -2.42085 2.52867 6.94663 -213 2 7.68553 12.1691 4.45091 -10.6399 7.25218 24.1014 -214 1 14.4389 4.03262 3.28382 -1.54769 2.04788 0.687462 -215 2 14.9998 3.98927 4.07922 -0.140352 3.9435 -3.93632 -216 2 13.6855 4.60992 3.49399 3.24138 -5.01437 4.30138 -217 1 5.6049 1.66195 7.51556 2.43321 19.3851 -35.7094 -218 2 4.99817 1.05358 7.93111 -11.2062 -8.09843 6.71806 -219 2 5.29033 1.73413 6.56196 15.7086 -7.98236 30.9511 -220 1 17.8679 1.11465 4.8662 -8.84521 -11.3875 -0.414623 -221 2 18.5938 1.34898 4.28573 7.92092 9.45731 -1.66923 -222 2 17.9348 1.63294 5.67672 2.41874 4.31495 -1.38437 -223 1 6.82183 9.41821 4.49596 0.331068 -0.81956 4.69879 -224 2 6.92763 9.68813 5.42975 0.55668 -5.9518 -10.6641 -225 2 7.69076 9.13696 4.17138 2.49623 1.53594 7.84385 -226 1 2.6692 14.9191 1.96889 -13.7427 -15.0981 33.3863 -227 2 3.22272 14.7135 2.75628 -3.53882 5.4164 -17.9931 -228 2 3.23582 15.271 1.30455 16.0902 7.51076 -16.3339 -229 1 17.3236 12.914 13.1856 6.20451 10.459 -3.7314 -230 2 16.5162 13.3803 13.3896 -16.2035 -4.78456 4.03007 -231 2 17.8657 13.6659 12.9192 5.22743 -7.26423 -1.93052 -232 1 14.957 10.5619 1.40158 33.4378 15.8576 14.4167 -233 2 15.5687 11.2535 1.77718 -16.3935 -17.8486 -10.6273 -234 2 14.0947 10.9454 1.47451 -15.7071 3.57407 -1.68856 -235 1 5.70225 6.80052 4.56184 6.57688 14.9147 -7.26545 -236 2 6.13296 7.68472 4.64206 -12.0226 -12.483 -2.28626 -237 2 6.28869 6.17268 5.00191 2.5554 2.13057 5.94298 -238 1 8.01258 8.29623 10.2593 -8.54796 -9.21297 9.02749 -239 2 8.56841 9.06789 10.0886 3.62647 -1.62136 -15.6888 -240 2 7.62542 7.94814 9.4343 7.03713 6.69092 4.95874 -241 1 13.441 18.4149 5.75957 4.19405 2.302 -13.2138 -242 2 12.6243 0.255994 5.52243 8.89948 -2.22339 5.88848 -243 2 13.1991 17.7887 6.44621 -5.69407 0.108635 9.70575 -244 1 0.157493 2.61527 0.174457 -9.01339 -22.8294 -0.321401 -245 2 17.938 2.88173 18.4446 6.58659 5.28303 7.29983 -246 2 0.732894 3.35773 0.380844 -2.17088 12.8237 -3.11298 -247 1 12.7457 11.0391 9.7485 36.4778 -29.6492 25.4167 -248 2 11.881 10.9734 9.40839 -39.1103 -1.43989 -11.0388 -249 2 12.9187 10.1217 10.0968 -0.290925 20.2268 -9.99681 -250 1 0.740308 12.1745 11.0603 -22.9837 8.27774 -1.01284 -251 2 18.4139 12.2368 11.1424 7.83285 -3.43363 -6.48653 -252 2 1.04445 12.5328 11.8929 13.1768 -0.7817 9.81141 -253 1 5.09631 7.29496 13.4329 -5.02176 -6.40528 2.12919 -254 2 5.65923 7.87015 12.9013 0.281799 7.42737 5.37855 -255 2 5.54275 7.21467 14.2893 3.22018 -2.41867 -5.38403 -256 1 1.21307 6.88521 11.8471 45.2055 23.2855 19.4361 -257 2 0.504281 7.33909 11.418 -17.6401 7.5893 -9.966 -258 2 1.85566 7.62216 12.1147 -28.9146 -29.9066 -6.84092 -259 1 15.4951 9.58282 12.318 3.7565 -9.08444 -2.54037 -260 2 14.9885 10.3731 12.1762 -1.60608 19.4691 -5.65324 -261 2 15.197 9.26603 13.1641 1.66558 -4.92983 10.8479 -262 1 16.5876 12.7654 5.4778 8.29992 -4.99789 29.9812 -263 2 16.3841 13.7077 5.58453 -1.61151 1.51391 -8.42869 -264 2 16.4534 12.5134 4.57091 -6.79319 5.2662 -20.9737 -265 1 6.24519 9.93185 0.0511849 19.8307 -8.34124 26.5163 -266 2 5.62326 10.391 0.623031 -8.96333 4.37615 -1.09153 -267 2 7.04636 9.86115 0.632167 -14.2701 4.68407 -14.2447 -268 1 12.3094 6.10151 4.07154 29.4526 9.60181 -18.9544 -269 2 12.3581 6.67925 3.27122 -7.72489 -2.14158 19.4346 -270 2 11.4533 5.70734 4.07903 -24.5921 -5.49884 -2.8127 -271 1 0.238725 12.7856 0.183979 8.51406 3.08383 0.253195 -272 2 0.144933 13.4932 0.833619 -6.86037 1.22763 2.8825 -273 2 18.4214 13.096 18.0418 -3.66036 2.31192 -5.9902 -274 1 3.70956 18.598 8.57987 -8.91795 8.796 11.4474 -275 2 3.55449 18.0356 7.80833 -3.96611 6.10323 -0.149317 -276 2 2.8446 0.378518 8.78385 11.2365 -8.2841 -4.38951 -277 1 7.48876 17.3305 4.49636 -9.17434 -25.7083 -0.449464 -278 2 7.67261 18.2518 4.49855 7.01126 32.4538 5.60223 -279 2 7.56532 17.0943 3.57389 -1.71949 -1.63571 -7.00131 -280 1 9.24209 17.1007 12.2607 -0.0867103 -4.31389 -13.5747 -281 2 9.30622 16.4126 11.5797 -4.40084 -0.983353 3.37399 -282 2 10.1228 17.1279 12.6444 4.44927 1.46684 7.86514 -283 1 13.3362 12.9421 7.98122 6.55916 41.1429 -16.6734 -284 2 13.3796 12.1892 8.55526 4.57885 -11.5398 14.8452 -285 2 13.9495 13.647 8.31623 -8.21726 -16.9651 -6.13203 -286 1 14.9343 2.98184 15.3399 -18.8859 -3.08059 15.3623 -287 2 14.3306 2.22694 15.2091 8.05839 6.56319 -1.64083 -288 2 15.5611 2.99492 14.6188 6.00199 -3.60128 -9.94013 -289 1 9.8611 15.5568 16.9864 -5.18568 1.15062 7.50023 -290 2 10.3014 14.7282 16.7357 2.8278 3.85059 0.776615 -291 2 9.42894 15.4199 17.8518 3.24739 -0.30663 -9.25648 -292 1 11.3089 8.34774 16.5637 -8.99518 -4.25182 3.40254 -293 2 10.6351 7.93491 15.9913 5.93093 -1.15278 9.90769 -294 2 11.3777 7.78039 17.3602 -0.876032 6.75541 -11.8921 -295 1 3.86263 18.1743 16.7605 8.31608 -24.0238 3.67333 -296 2 4.34809 17.526 17.3016 -5.03788 -1.4921 -11.4176 -297 2 3.91859 0.291346 17.3034 -3.84782 28.4328 8.21839 -298 1 2.18675 4.1526 8.92206 -24.1698 7.19476 -17.4672 -299 2 3.08777 4.02084 8.66345 19.2563 -3.88604 2.84364 -300 2 2.11989 4.14607 9.87269 6.11123 -7.11558 17.6044 -301 1 9.878 10.3743 9.69372 5.53967 -18.4491 14.0185 -302 2 9.43572 11.1423 9.3425 -1.35277 14.796 -0.820696 -303 2 10.0526 10.4842 10.6451 0.294207 2.81912 -6.3598 -304 1 9.67606 0.861397 10.8616 12.1631 -0.119776 7.34561 -305 2 9.24662 0.0503119 11.2005 -2.60905 7.79605 -9.27605 -306 2 9.17358 1.27941 10.1433 -7.66403 -7.87567 2.43043 -307 1 9.19351 15.1133 10.2188 11.11 2.94282 0.236533 -308 2 8.72034 15.7288 9.64731 -2.95318 7.0206 -0.021652 -309 2 8.61234 14.3559 10.3013 -9.273 -0.749783 0.810803 -310 1 0.983709 9.49699 10.2982 -74.1988 19.4185 4.2569 -311 2 0.893433 10.4494 10.5162 13.7438 -13.7231 -2.84852 -312 2 1.86549 9.26486 10.2468 58.3196 -6.52918 -3.90093 -313 1 16.9084 4.83943 8.1598 4.06942 21.6595 -28.8412 -314 2 16.3724 5.61591 8.36865 -1.41178 -4.09344 3.51719 -315 2 16.8393 4.26054 8.89216 -0.699807 -17.3102 23.1105 -316 1 14.7125 14.7098 0.257213 21.3866 7.73012 -2.74727 -317 2 15.2455 15.0698 0.987096 -5.24332 1.02996 -2.3964 -318 2 13.934 14.3364 0.654485 -15.8904 -6.61515 6.72623 -319 1 3.61962 11.0361 9.55343 7.54802 -1.42323 12.4812 -320 2 3.62776 11.3571 10.4773 -0.544226 1.54555 -6.56144 -321 2 3.18313 11.7186 9.01674 -3.18494 -0.813089 -1.4949 -322 1 11.1481 10.7794 1.3867 -18.0125 -13.9714 2.13506 -323 2 11.5419 11.6189 1.17487 5.50703 16.2749 -10.1623 -324 2 10.2377 10.7815 1.02242 13.9743 0.382042 6.15217 -325 1 13.1644 7.14571 12.7934 28.1674 11.2254 -0.0108115 -326 2 14.1505 7.05998 12.7803 -16.3048 -3.53009 2.57838 -327 2 12.835 6.25234 12.9024 -6.40061 -9.363 -1.95696 -328 1 9.62034 1.87073 0.979069 -6.9897 -0.645983 -14.1021 -329 2 8.86926 1.41829 0.528843 9.90899 13.9476 5.87182 -330 2 10.1257 2.37739 0.312436 -3.40486 -11.198 4.68953 -331 1 10.6367 13.5403 4.62088 -14.2461 -11.7796 -9.34504 -332 2 11.3649 12.9086 4.64313 9.4379 4.41524 3.81629 -333 2 10.614 13.9519 5.48444 4.98914 7.07 10.6976 -334 1 14.3951 1.77229 10.9373 11.882 -13.8992 0.14286 -335 2 15.2529 1.46692 10.5904 -8.80209 -5.09491 0.192719 -336 2 14.4998 2.72321 10.9422 -3.89457 8.74507 -1.42899 -337 1 14.6035 12.2778 11.6732 8.28457 -2.47972 34.5189 -338 2 15.3822 12.4706 11.1386 -1.8445 -1.29245 -12.2333 -339 2 13.8238 12.1274 11.1597 -9.6117 -2.29221 -24.4043 -340 1 8.21682 5.05944 9.82725 33.2235 -12.7421 -22.1109 -341 2 7.50249 5.31613 10.3805 -26.8995 -2.6371 14.604 -342 2 8.16278 4.09579 9.61432 -6.39419 19.305 4.57693 -343 1 1.57178 16.8746 18.3696 -12.5949 -28.7752 19.8992 -344 2 1.95856 17.2997 17.6256 12.4489 12.7929 -23.944 -345 2 1.61191 15.9133 18.1414 3.74732 18.7705 7.54273 -346 1 1.50483 17.2622 15.3369 -31.2805 -0.211241 0.372367 -347 2 1.56428 18.1715 15.7008 -8.02099 -13.4799 -3.86937 -348 2 0.550545 16.944 15.3287 29.8388 16.9503 2.40621 -349 1 3.67189 5.70682 6.10259 2.52977 5.35962 -6.45813 -350 2 3.10512 6.24939 6.65687 -5.8484 1.84291 7.09291 -351 2 4.11645 6.33532 5.504 1.86189 -8.61654 4.18176 -352 1 12.4205 9.46682 14.1922 0.00765934 6.29699 5.01976 -353 2 12.7713 8.66673 13.7826 1.27338 -5.49384 -0.333278 -354 2 12.2037 9.20626 15.0998 2.51081 -2.42178 -0.168732 -355 1 4.04257 15.2822 6.8914 -27.6779 4.92775 8.06061 -356 2 3.56316 16.0906 6.63798 2.42102 -8.57509 -1.16647 -357 2 4.95231 15.5118 6.77617 25.3206 1.78005 -4.31003 -358 1 0.630616 8.59357 14.9621 0.0534875 13.3347 6.63524 -359 2 0.475879 9.54739 15.0951 0.802494 -5.58418 -0.636111 -360 2 1.32488 8.5708 14.2996 4.58301 -1.27906 -6.75903 -361 1 12.9988 8.28033 10.3217 -21.3611 19.4324 1.5895 -362 2 13.6573 7.74741 9.88515 12.8548 -10.016 -2.83384 -363 2 12.9714 7.9897 11.246 0.968107 -4.04745 -5.09921 -364 1 15.3184 7.7322 3.54707 4.18654 -9.90345 10.9868 -365 2 14.6375 7.17364 3.22195 -21.9236 0.488691 -25.4272 -366 2 15.542 7.2045 4.31452 16.9904 15.0521 14.7627 -367 1 17.298 6.68564 0.0426033 13.9193 -14.0885 -0.920406 -368 2 16.8642 5.82471 0.139777 0.0396094 5.05794 2.76644 -369 2 16.6003 7.28204 18.4358 -17.9105 11.3609 -4.38582 -370 1 8.85442 6.93876 7.83202 25.5204 20.9839 -12.9835 -371 2 9.78415 7.28149 7.87459 -21.3181 -5.86923 -3.23496 -372 2 8.81067 6.25344 8.49096 -5.61401 -13.4392 14.4413 -373 1 12.3763 0.596552 1.22002 -1.17453 2.99561 6.82033 -374 2 13.3385 0.528874 1.30915 -5.26207 -0.953155 0.827968 -375 2 12.0852 0.273415 0.369127 5.54968 -2.26078 -4.64309 -376 1 5.63283 15.1348 14.5573 -11.4131 -7.08845 -3.56826 -377 2 4.66833 15.2302 14.6984 9.61439 -4.03287 3.27369 -378 2 5.92452 15.9751 14.1944 7.77409 8.39082 -1.96781 -379 1 3.86657 6.44559 1.75085 5.80409 -14.6499 1.98717 -380 2 3.55249 7.31671 1.4889 -5.45171 9.45984 0.647045 -381 2 4.14269 6.4981 2.68117 -5.39897 6.08822 -6.8935 -382 1 3.91507 11.6157 12.3486 -13.4135 -1.42429 5.74998 -383 2 4.7693 12.0145 12.538 6.44699 -0.479912 -1.2837 -384 2 3.27735 12.1325 12.8813 7.77399 -7.15276 -11.5357 -385 1 5.36262 3.86651 15.8768 12.1389 -59.3419 -3.52329 -386 2 6.1064 3.19888 15.7551 -26.8485 22.8054 1.66706 -387 2 5.75212 4.71249 15.8089 15.627 34.646 -1.2618 -388 1 14.3819 10.2457 4.44716 -17.5064 5.46907 41.0935 -389 2 14.5449 9.71992 5.26671 -1.94493 10.8322 -14.5796 -390 2 14.8723 9.82528 3.76702 14.2142 -16.5996 -23.0963 -391 1 7.82031 17.402 9.18196 15.4978 -20.6961 5.52716 -392 2 6.95708 17.6159 9.5372 -6.73409 6.75657 -1.79958 -393 2 8.0438 17.9374 8.41052 -8.48575 5.6988 -1.01071 -394 1 4.52697 14.5011 3.99561 -1.64824 1.80571 -15.4173 -395 2 4.43911 15.4257 4.28139 2.0309 -4.99506 3.13673 -396 2 4.3827 13.9072 4.73582 -0.0495062 -0.930109 11.2178 -397 1 14.2192 7.41869 15.785 -17.5888 -3.59777 -10.979 -398 2 15.1626 7.35697 15.6947 20.631 -1.7403 -3.62609 -399 2 14.073 7.80524 16.6426 0.667235 5.42077 11.7037 -400 1 2.9565 18.2605 1.91108 1.19197 -18.909 -26.3864 -401 2 2.43337 17.7432 1.2423 11.354 8.34367 16.4878 -402 2 2.37308 0.276014 2.2689 -15.3488 13.3111 9.03739 -403 1 8.00359 1.60253 4.55907 -38.5212 -7.91491 7.83452 -404 2 7.38229 2.10405 3.99193 12.1921 -3.74558 1.60605 -405 2 8.88232 1.74243 4.26439 24.0023 10.0694 -13.3902 -406 1 2.4736 14.1336 17.6839 19.5549 7.85258 6.07398 -407 2 1.90347 13.5339 18.1719 -6.00167 -6.95039 -0.586477 -408 2 3.38553 13.9045 17.9683 -9.72011 -2.72883 -0.373401 -409 1 0.820064 1.73894 13.8888 -18.5285 5.33114 2.4032 -410 2 0.803771 1.49328 14.8397 -2.66487 6.43341 -16.8821 -411 2 18.5531 2.02517 13.6233 21.0072 -9.49287 13.5993 -412 1 4.44957 0.0409644 13.9204 -25.6038 8.03756 8.31677 -413 2 5.34611 18.3721 13.8825 17.1601 -8.5878 1.82821 -414 2 4.09536 18.4705 14.8092 8.9848 -0.155186 -10.4675 -415 1 7.11939 0.665063 18.3496 37.4596 -16.3367 -22.9959 -416 2 7.39046 0.248229 17.4868 -7.59422 10.3961 22.0522 -417 2 6.17976 0.73857 18.3349 -24.6121 7.91301 3.99406 -418 1 16.0679 18.4255 14.0033 46.948 4.07246 14.5496 -419 2 15.1925 18.2569 13.7481 -41.7006 -8.82757 -2.39817 -420 2 16.1514 18.46 14.9783 -11.5795 5.15321 -10.1321 -421 1 10.0899 4.51466 16.2755 46.1692 31.6348 -9.79269 -422 2 11.0262 4.80528 16.0633 -26.3332 -3.27592 13.4521 -423 2 10.217 3.58436 16.3451 -11.2214 -29.3564 0.661634 -424 1 15.916 17.7977 4.41903 32.6965 1.49817 -6.30174 -425 2 16.457 -0.0326327 4.45612 -4.70593 -7.03645 1.74937 -426 2 15.0663 18.0576 4.73092 -30.5769 8.16516 8.13282 -427 1 7.01211 17.4116 13.808 -11.1093 -0.0306798 -7.53718 -428 2 7.48321 17.731 14.5797 1.71822 -1.35338 6.01299 -429 2 7.70771 17.2257 13.1599 -0.832239 2.47859 1.40448 -430 1 13.2731 6.49483 6.63036 5.49864 12.0855 21.8831 -431 2 14.0036 7.1367 6.53142 -6.95912 -13.4785 -6.50558 -432 2 12.9191 6.26998 5.7719 1.78547 5.07661 -13.1828 -433 1 7.78873 2.35817 9.26787 13.6578 7.92928 32.9359 -434 2 7.26595 2.28464 10.098 4.41261 -4.66671 -14.4408 -435 2 7.24114 2.08424 8.54668 -18.4281 -7.28868 -15.4379 -436 1 15.1807 14.8213 13.6836 12.0158 -14.5979 1.51453 -437 2 15.023 15.1631 14.5679 -5.44227 3.64048 5.06686 -438 2 14.7818 15.3898 13.0312 -8.03448 9.52233 -3.65179 -439 1 9.37687 8.31604 3.76928 5.34304 4.19186 5.02399 -440 2 10.2244 8.59911 4.15846 -6.46746 6.21109 -7.45595 -441 2 9.38739 7.36131 3.86692 -0.369722 -6.10407 -0.56198 -442 1 17.7826 13.5587 16.3931 -18.259 -13.3606 7.93732 -443 2 16.8564 13.2543 16.3515 3.23179 3.05811 2.18424 -444 2 17.7493 14.412 15.956 6.45918 8.6709 -4.68033 -445 1 4.96945 10.6182 2.7671 -20.0352 21.3698 -14.9929 -446 2 5.67156 10.2863 3.30832 14.7689 -7.42384 15.9186 -447 2 4.73305 11.5 3.12196 4.54065 -18.1741 -2.81522 -448 1 3.75186 8.34553 10.1595 -2.54049 11.5371 -18.7835 -449 2 3.83158 9.28658 9.87851 -1.62744 -10.9109 6.60301 -450 2 3.69687 8.33176 11.111 2.12623 4.07512 13.0596 -451 1 16.0105 7.02075 6.14683 -8.93467 17.9282 -2.69417 -452 2 16.8191 7.42843 6.45697 9.04966 6.41713 2.22097 -453 2 16.1641 6.09023 6.1704 3.21598 -21.4167 -2.94797 -454 1 15.1148 7.07457 9.06702 4.51295 -11.3361 21.5265 -455 2 15.7278 7.43111 9.72685 3.64545 -0.886375 -6.04752 -456 2 15.1684 7.6713 8.33808 0.281889 14.352 -20.2518 -457 1 6.32562 13.0044 12.7823 3.64263 -12.4915 -10.2251 -458 2 7.18031 12.5985 13.0233 -9.44077 2.88231 5.28619 -459 2 6.10277 13.6925 13.4113 4.07235 10.5841 12.4872 -460 1 12.13 4.50388 13.0978 -23.9143 -18.2098 -29.5576 -461 2 12.2018 4.66005 14.0386 -4.52664 -3.61945 12.4396 -462 2 11.31 3.95423 12.8708 29.5104 21.9629 17.7949 -463 1 11.3628 8.1671 7.89263 -5.63688 4.26156 -3.21905 -464 2 12.0486 7.63378 7.48497 5.26632 -9.68169 -9.18733 -465 2 11.6596 8.25059 8.79652 3.08614 3.11673 13.4283 -466 1 17.1728 10.8467 7.48683 -9.78257 9.61375 -3.53187 -467 2 17.8082 10.1926 7.21604 13.2987 -16.4259 3.23364 -468 2 17.1151 11.4269 6.71399 -11.2446 1.98681 4.69156 -469 1 5.26156 18.1118 11.0164 11.279 0.780011 3.76881 -470 2 4.63029 17.9037 11.706 -3.79608 -1.61163 6.00067 -471 2 4.75114 18.4846 10.3039 -10.5863 -2.03901 -14.6626 -472 1 7.60927 17.5116 1.80376 -12.2084 0.332405 -16.0787 -473 2 7.73547 16.6894 1.27511 4.49641 20.7738 7.60921 -474 2 7.29137 18.2078 1.17993 10.7818 -15.1152 7.96202 -475 1 1.93242 12.9038 13.5907 -11.1009 -8.62515 -2.91716 -476 2 1.44204 12.3193 14.1878 -0.742257 0.132846 -0.79095 -477 2 2.14259 13.6778 14.1103 6.96653 11.7909 8.84583 -478 1 9.6349 6.79099 14.8483 -7.90933 -4.5792 7.57822 -479 2 9.76837 5.84646 15.0736 0.917781 12.494 -4.6794 -480 2 9.97866 6.97841 13.9703 0.736717 -7.57275 -8.26148 -481 1 15.2733 4.3257 10.7584 -18.0594 -0.89979 -6.45033 -482 2 16.1458 3.96681 10.9687 3.533 12.3702 4.36819 -483 2 14.9475 4.94569 11.4317 15.7147 -3.56113 0.605423 -484 1 11.2438 6.16931 0.179082 0.0277951 -2.16566 -3.90965 -485 2 11.3357 5.30361 18.4317 14.8036 -12.0621 -1.88578 -486 2 10.2956 6.2638 0.1816 -11.5861 14.503 2.02073 -487 1 0.0439986 11.3816 15.0585 -6.49496 4.09431 2.20477 -488 2 18.034 11.5578 14.353 7.75523 3.54925 4.26198 -489 2 -0.111373 12.1024 15.7029 3.25408 -7.01329 -10.5532 -490 1 7.06114 9.23722 7.26386 23.5376 12.3273 -0.106793 -491 2 6.50127 8.56776 7.63843 -10.2441 -19.5548 5.03643 -492 2 7.97426 8.90952 7.38371 -13.166 2.65106 -3.29749 -493 1 18.3483 15.3728 12.3401 -6.10947 1.64082 -0.490965 -494 2 0.640544 15.4003 12.1341 13.3619 2.30286 0.418231 -495 2 17.9315 15.8707 11.6253 -4.70162 -1.66258 -3.35097 -496 1 16.5284 4.37134 5.23872 23.865 15.8443 -24.0922 -497 2 16.795 4.23475 6.13242 -1.17196 -10.8972 27.7735 -498 2 17.3848 4.63349 4.80865 -25.3878 -11.1359 -1.24016 -499 1 17.7266 3.13043 10.7284 -15.1505 -16.4799 -4.03799 -500 2 -0.0205156 3.31599 11.0266 10.8372 -1.61224 -0.261482 -501 2 17.686 2.21262 10.3629 5.98361 15.5222 5.29053 -502 1 12.2768 0.00077952 10.1229 -5.39949 -11.0736 -0.564535 -503 2 11.3994 0.337416 10.3512 -3.44242 -0.519791 1.58275 -504 2 12.8621 0.740723 10.2534 12.1364 13.942 1.61795 -505 1 10.3933 9.78571 12.4371 -17.696 -6.66554 -9.33286 -506 2 11.04 9.8019 13.1479 9.02187 0.111511 2.28178 -507 2 10.1583 8.84624 12.3274 6.95171 5.58218 -0.582165 -508 1 0.583846 2.83323 7.01904 8.81732 -31.8654 7.83245 -509 2 0.599611 3.49885 7.68934 -3.58556 22.6003 9.07619 -510 2 0.952398 2.07883 7.51841 -6.10214 6.37924 -11.0018 -511 1 0.367433 15.2949 6.92522 -4.7012 3.61818 34.4112 -512 2 0.558547 14.7156 7.70153 -1.71176 22.246 -5.06421 -513 2 0.60814 14.7658 6.19753 10.4713 -26.0103 -27.8181 -514 1 17.0409 7.00624 15.2099 -22.5014 1.92016 -1.24665 -515 2 17.7387 7.65639 15.0691 10.2085 -5.07189 3.59706 -516 2 17.3996 6.21947 15.6455 8.09739 1.82665 -3.45815 -517 1 9.08645 12.4582 8.07298 60.2845 4.68897 0.226728 -518 2 9.45122 11.8173 7.41895 -17.2892 5.38378 7.41181 -519 2 8.16079 12.445 8.11596 -46.4448 -7.25102 -10.4423 -520 1 1.26434 1.84534 2.97351 6.14985 -4.32801 10.6126 -521 2 0.602074 2.03133 2.30849 -1.31532 11.5451 -8.74279 -522 2 1.61884 2.681 3.33622 -3.80121 -10.2767 -5.51985 -523 1 4.10472 15.1163 9.79145 -1.9934 -0.675971 8.59173 -524 2 4.064 15.4281 8.88095 5.53492 -3.39313 -4.80569 -525 2 4.98866 14.7298 9.93327 -5.1567 4.83883 -4.62826 -526 1 7.25259 2.18349 14.6213 0.0617677 -13.2081 -4.74626 -527 2 7.15489 1.70536 13.7831 -3.1697 0.657011 7.79217 -528 2 7.60954 3.02479 14.3607 5.63067 15.2107 -2.58221 -529 1 18.5424 14.6505 2.1789 -18.2195 12.8357 -3.23587 -530 2 0.746704 15.0923 2.14855 14.3998 1.01071 2.70778 -531 2 17.888 15.3836 2.15154 2.4051 -14.4939 -0.146303 -532 1 9.96619 2.7451 12.9133 2.94451 10.1866 18.8487 -533 2 9.87163 2.03702 12.2777 -5.79326 -7.02869 -14.8001 -534 2 9.15272 3.27293 12.9211 3.46257 -1.15836 -6.04557 -535 1 2.89008 8.93457 13.069 -0.378913 -4.03455 -0.489948 -536 2 3.23396 9.82093 12.8894 1.3587 3.50504 -2.14294 -537 2 3.63423 8.44035 13.4383 1.00579 -2.11175 -2.13579 -538 1 3.23705 8.4538 3.70316 6.66602 15.0067 -51.1451 -539 2 3.68898 9.21355 3.2191 -13.1992 -22.9024 22.1933 -540 2 3.37321 8.55056 4.62635 6.35333 11.1623 30.2444 -541 1 5.63533 7.19464 8.56829 15.13 5.19196 -11.3333 -542 2 5.75579 6.23215 8.63413 -6.09463 5.83127 4.58457 -543 2 5.06463 7.50349 9.27803 -5.30623 -7.19668 4.50769 -544 1 14.8805 1.37043 1.98087 -12.9306 20.6627 -0.801435 -545 2 14.4834 2.20569 2.28334 5.69168 -11.9007 13.5915 -546 2 15.1168 1.59638 1.09054 15.1066 -6.121 -14.4277 -547 1 8.35206 15.1867 0.801551 -2.76223 -14.7585 -5.29804 -548 2 9.12264 14.9643 1.32951 11.031 8.33032 8.58299 -549 2 7.67017 14.6008 1.15941 -5.63761 -0.337967 -3.00039 -550 1 15.5896 1.3528 7.2086 5.32958 13.3681 13.2076 -551 2 15.0272 0.817571 6.66531 -11.4451 -13.4108 -9.89715 -552 2 14.9993 2.0562 7.52457 4.21653 3.3566 -1.64766 -553 1 5.02591 13.0452 18.4884 -9.20414 -3.59717 -21.6247 -554 2 5.46138 13.1397 0.681872 7.63488 2.92653 16.7381 -555 2 5.72796 13.1696 17.8326 -7.15584 3.38504 4.08457 -556 1 15.3795 8.51367 18.1423 -0.613664 -0.0581633 13.6311 -557 2 15.7206 8.99589 17.3938 3.47957 9.7554 -12.9134 -558 2 15.3333 9.18442 0.205917 -4.60531 -6.1888 -2.54679 -559 1 12.0939 3.05244 18.336 -15.98 21.6351 4.66001 -560 2 12.5019 2.66242 0.476891 0.147771 -8.75739 -8.71627 -561 2 12.3559 2.60872 17.5248 9.46456 -12.7769 5.34739 -562 1 13.1875 12.6757 5.16147 -9.52799 6.20775 -2.46737 -563 2 13.6969 11.8811 4.95337 3.5398 -1.69434 3.58065 -564 2 13.2525 12.8475 6.11376 6.90446 -8.64397 -1.04625 -565 1 6.03627 7.1613 0.0926319 -1.4976 11.1377 0.14104 -566 2 5.76921 8.10211 0.154014 9.70457 -9.32393 -3.08293 -567 2 5.20613 6.68485 0.159604 -1.55619 -3.41243 3.21991 -568 1 17.685 15.9184 14.9825 -1.37425 0.537856 -17.3926 -569 2 16.8502 16.3506 14.966 -20.4161 12.6054 20.7942 -570 2 17.7239 15.7506 14.0369 24.1644 -10.6132 -5.26117 -571 1 13.1805 0.948047 16.6125 -8.26177 1.73564 3.5107 -572 2 14.0455 0.715926 16.9626 7.25254 0.595142 -3.17693 -573 2 12.7267 0.0993777 16.5408 2.533 -1.4889 -4.3323 -574 1 11.0204 14.5878 7.33132 -13.7805 -25.7938 -0.586216 -575 2 10.2983 13.987 7.62969 9.87943 15.8321 -1.01987 -576 2 11.8217 14.058 7.45361 -0.254224 3.6388 3.5388 -577 1 17.5119 8.53957 2.08465 9.75653 -12.9638 -10.6953 -578 2 16.6633 8.36471 2.52368 3.0717 -2.74041 -4.8374 -579 2 17.6343 7.8268 1.40004 -7.84255 17.4574 20.9547 -580 1 12.3495 7.93856 1.97915 15.2682 -24.1922 3.95646 -581 2 11.8245 8.73298 1.97607 -8.33179 10.3297 -5.28986 -582 2 12.0289 7.32679 1.29658 -2.64171 9.95394 1.06163 -583 1 11.9622 14.6462 10.3592 5.19436 44.1652 25.6085 -584 2 12.1561 13.8266 9.98193 3.67183 -41.4058 -22.2867 -585 2 11.0169 14.8072 10.2884 -7.2612 -3.28322 -4.25289 -586 1 6.85285 6.99572 15.5659 -14.0155 -24.0568 -12.8099 -587 2 7.75988 6.91015 15.2685 9.48733 7.04308 1.07731 -588 2 6.80041 7.76332 16.11 4.63477 18.9896 15.1539 -589 1 8.01222 4.65145 13.4113 -36.8067 -34.3033 -31.6859 -590 2 7.3316 4.83402 12.7007 16.1602 -3.60309 24.697 -591 2 8.38377 5.47541 13.6286 15.6027 34.5994 6.21753 -592 1 13.4241 12.174 14.3057 -4.84328 6.02619 2.2323 -593 2 13.1628 11.2453 14.2138 0.984992 -0.986947 -4.38535 -594 2 13.8661 12.446 13.4834 -0.550032 -4.72607 1.54363 -595 1 14.7341 9.44221 7.2791 -5.07947 3.15833 13.2143 -596 2 15.5444 9.94699 7.52972 -16.5583 -4.09464 -2.76463 -597 2 13.9842 9.66778 7.87655 21.0159 1.38057 -11.435 -598 1 12.706 16.9897 3.14089 12.6698 -33.6085 3.29803 -599 2 12.7844 17.2146 4.05845 5.40916 5.57996 15.4808 -600 2 12.1668 17.6603 2.78193 -20.8699 29.0634 -19.4792 -601 1 1.09001 7.14262 17.4001 -13.5934 2.13623 7.48936 -602 2 0.156991 7.24832 17.6908 14.7769 -7.58529 -2.77652 -603 2 1.13731 7.55625 16.5284 -2.3111 1.37932 -0.487878 -604 1 12.8562 5.06495 15.6988 -8.68567 -0.702669 -5.76624 -605 2 13.5471 4.4122 15.5538 8.1837 -6.12965 4.55719 -606 2 13.3218 5.91347 15.6395 -0.893164 2.09785 3.54679 -607 1 2.45402 3.36746 5.11563 -15.0026 -7.91555 0.636238 -608 2 1.84292 3.24382 5.86687 4.72922 -2.7794 -8.95345 -609 2 2.91216 4.18226 5.3072 9.55717 10.9124 5.44962 -610 1 8.31869 11.1649 13.5414 -26.3953 31.2189 -67.0184 -611 2 8.3305 10.9362 14.4299 14.6498 -23.9054 54.2316 -612 2 8.96182 10.7076 12.9898 15.0794 -7.45176 14.931 -613 1 12.9219 1.43726 13.3082 8.40674 -27.4269 12.3988 -614 2 13.6356 1.33586 12.6838 7.08718 -5.3 -10.143 -615 2 12.6036 2.28403 13.0872 -17.61 33.9058 -2.44667 -616 1 6.45277 13.6094 2.15178 17.7292 -13.553 0.669437 -617 2 5.88225 13.9257 2.84987 -12.2826 9.62032 8.12495 -618 2 7.05696 13.0019 2.62135 -3.25561 7.9246 -7.28354 -619 1 15.9319 6.53462 12.7261 -1.3149 8.22476 -13.019 -620 2 16.4256 7.00237 12.02 -4.18033 -7.18445 13.3481 -621 2 16.3662 6.74364 13.5705 0.249391 -3.37031 -2.78146 -622 1 16.8119 0.703827 9.59317 0.0549178 13.2549 -11.7388 -623 2 16.9772 18.4048 9.65541 -4.88295 -11.6626 5.05601 -624 2 16.4803 0.847119 8.68154 -1.08178 -1.2883 7.79904 -625 1 6.11652 11.6489 8.33522 -7.45125 2.78057 4.10213 -626 2 5.22601 11.4682 8.68918 7.08294 1.77705 -0.544493 -627 2 6.44454 10.7788 8.07724 4.19277 0.895061 -4.04259 -628 1 2.82334 8.71064 0.367814 57.5944 7.33247 25.2144 -629 2 2.2601 8.16366 18.5098 -36.527 -13.587 -20.7071 -630 2 2.37171 9.41868 0.829256 -17.9324 0.137834 -3.43482 -631 1 10.1122 10.4601 6.54653 2.23323 -6.08635 8.59596 -632 2 10.5188 9.74717 7.06727 -1.60105 2.20328 -1.71973 -633 2 10.6949 10.5759 5.79445 1.91861 -2.10956 -11.6412 -634 1 6.75321 15.7504 6.59889 15.4627 0.902891 -8.22878 -635 2 7.26857 15.9454 7.3825 -2.17992 1.48032 8.28293 -636 2 7.22097 16.2558 5.90647 -13.1985 0.138133 2.05084 -637 1 6.44152 13.0383 5.65846 10.3967 8.14078 0.466175 -638 2 6.75357 13.9433 5.8413 -7.70657 -8.59676 1.70002 -639 2 6.06189 12.7174 6.48437 -0.213232 -3.44089 0.434225 -640 1 16.7867 12.5398 9.78373 -0.895423 12.3409 14.8939 -641 2 16.908 11.9251 9.05274 5.68732 0.178616 -8.50939 -642 2 17.2058 13.3939 9.58039 -4.06144 -12.2084 -5.14549 -643 1 6.11722 2.93773 2.78358 1.28645 13.216 -7.71479 -644 2 6.25944 3.86133 2.4934 3.99356 -9.45804 11.966 -645 2 5.80949 2.50246 1.9813 -4.27697 -8.38821 -0.209888 -646 1 10.8697 3.19981 3.26527 3.50346 -2.80617 2.55973 -647 2 10.3917 4.00785 3.47818 -6.11785 -2.03152 -1.59068 -648 2 10.4869 2.83625 2.45753 -2.48553 0.910808 2.03729 -ITEM: TIMESTEP -50 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.80494 6.94654 17.8995 24.4982 -1.06408 -3.00226 -2 2 7.9626 7.14317 18.2754 -25.5132 0.779993 7.28642 -3 2 8.754 6.09075 17.4755 -3.81212 -4.80634 -6.17786 -4 1 18.7076 8.28828 6.77862 -17.6183 19.7289 -45.7057 -5 2 0.378325 8.05756 5.8509 -9.14495 4.02657 32.4311 -6 2 0.533056 7.77742 7.41073 20.0311 -22.8668 16.2585 -7 1 8.47587 18.7144 6.8555 -15.9357 -0.720841 9.56566 -8 2 9.33674 0.260611 6.50709 17.8925 2.772 -5.71063 -9 2 7.894 0.699709 6.41588 1.40147 0.745568 -0.352682 -10 1 6.55032 1.74908 11.6806 -30.6389 -0.0206495 8.42613 -11 2 5.72229 2.20254 12.0188 30.9536 -14.8428 -8.23206 -12 2 6.26581 0.83583 11.4478 2.55871 18.5754 3.76962 -13 1 7.01034 5.66598 2.40366 42.8029 -38.9731 -13.6875 -14 2 6.35895 6.02285 2.96016 -30.9745 25.4116 27.1882 -15 2 6.9342 6.07183 1.55014 -9.7244 15.1829 -13.9093 -16 1 16.2046 10.2277 16.1038 24.2393 -12.7483 3.49627 -17 2 17.1446 10.5017 16.2161 -25.4373 -4.23616 -6.12234 -18 2 15.647 10.9645 16.3441 -0.0961828 13.5193 2.91036 -19 1 10.6483 14.9468 2.32679 16.6528 15.7411 4.7381 -20 2 10.6274 14.3584 3.09768 -0.623134 4.2367 -1.18236 -21 2 11.2712 15.6715 2.59359 -14.1521 -13.9994 -5.33424 -22 1 17.1661 8.23718 10.6306 -11.2967 1.73071 14.301 -23 2 16.7507 8.8212 11.3018 1.93853 -3.53361 -12.158 -24 2 17.9019 8.73965 10.2686 8.0864 2.26419 -0.719652 -25 1 14.7146 15.8737 16.457 -21.3602 13.4439 -13.9077 -26 2 13.7676 16.1527 16.3582 25.6738 -5.80999 2.03747 -27 2 14.7447 15.4629 17.3289 2.78446 -2.53877 0.107495 -28 1 12.1127 13.3961 0.516068 7.29043 -9.0569 -3.36162 -29 2 11.9491 13.4845 18.198 -4.88029 1.64951 11.237 -30 2 11.4672 13.8878 1.04861 1.29785 5.2885 -8.15688 -31 1 9.32313 5.46813 3.97213 7.80738 6.41636 -30.8752 -32 2 8.77956 5.22076 4.69796 -14.0602 -7.63701 27.6376 -33 2 8.66617 5.58024 3.26537 2.47672 -2.22308 0.129141 -34 1 1.75935 4.12111 11.6197 18.1342 -37.205 15.7411 -35 2 1.54791 5.00495 11.8916 -2.97584 25.4072 4.68628 -36 2 2.32145 3.72177 12.3424 -17.0092 10.631 -21.3466 -37 1 2.03979 6.80407 8.28533 9.98525 11.4794 16.6393 -38 2 2.53906 7.28349 8.98677 -9.97253 -7.08615 -13.1486 -39 2 1.84044 5.93856 8.67612 2.99865 2.8006 -7.53122 -40 1 5.41368 4.4431 7.98609 2.04847 -7.17668 -5.4397 -41 2 5.52021 3.53426 7.6768 1.69988 -8.04832 10.7211 -42 2 4.8597 4.83563 7.32005 -13.574 8.98698 -13.1921 -43 1 3.28639 2.94557 17.481 18.7711 -22.2673 -22.0629 -44 2 3.9564 3.24513 16.8336 -6.74837 -1.29983 9.82734 -45 2 3.01936 3.73284 17.9334 -14.3576 17.7403 14.3716 -46 1 7.43065 5.38409 6.1108 -4.02947 -12.3157 -7.88053 -47 2 8.04294 5.88377 6.62432 18.8075 23.5792 8.00277 -48 2 6.91671 4.96856 6.79731 -10.3369 -11.1081 4.55684 -49 1 9.79016 6.98523 11.9902 -10.4204 5.88316 -11.2143 -50 2 10.3735 6.44493 11.4296 -8.50476 3.87141 4.17676 -51 2 9.02941 7.28204 11.4255 18.3189 -8.29917 9.01359 -52 1 14.0741 3.64931 8.08693 10.5401 -0.215179 40.0548 -53 2 14.0167 4.44403 7.56769 -3.75439 10.9765 -10.3635 -54 2 14.3054 3.9684 9.00291 -5.13065 -9.75311 -28.2231 -55 1 4.53282 17.2396 3.96388 -3.36194 -12.9595 16.5635 -56 2 5.47422 17.3897 3.95236 14.0752 8.1678 -3.62607 -57 2 4.10275 17.6636 3.22639 -0.935466 5.38311 -16.6052 -58 1 16.4462 16.5922 10.2581 -38.5234 -1.88036 17.4962 -59 2 15.5721 16.6729 10.7424 33.2408 0.640367 -11.4138 -60 2 16.1948 16.0519 9.4989 1.36351 -0.703045 -4.07641 -61 1 1.99534 4.82647 0.326236 -5.72725 6.00108 -15.6714 -62 2 2.53752 5.17962 1.03714 5.87953 4.50688 4.90779 -63 2 1.76739 5.60304 -0.220726 -2.02535 -4.08014 4.56707 -64 1 11.5531 13.2812 16.3325 -4.55485 8.80091 5.86354 -65 2 11.0534 12.4701 16.4457 -6.69668 -7.45166 4.31247 -66 2 12.0841 13.1031 15.5561 8.82157 3.01133 -6.78989 -67 1 10.1577 11.0139 16.8858 -24.3839 23.6532 0.592397 -68 2 10.5791 10.1721 16.8528 10.3809 -28.4273 -2.47871 -69 2 9.20446 10.8554 16.7431 9.15295 -0.788439 1.53623 -70 1 11.769 17.4436 13.4724 -4.31264 31.1905 -3.85112 -71 2 12.3451 17.016 12.8258 4.51875 -1.42135 -0.782751 -72 2 11.9049 18.418 13.331 2.02313 -21.8103 4.25856 -73 1 6.43699 9.33747 12.2016 -14.3685 16.3251 29.571 -74 2 6.95929 8.94901 11.512 13.8657 -1.33735 -10.2504 -75 2 6.99936 9.91985 12.7612 -5.52999 -10.4188 -15.163 -76 1 16.2506 12.8362 2.68463 10.4823 17.07 -2.68352 -77 2 17.0784 13.3466 2.55935 -9.20242 -14.0812 1.4249 -78 2 15.565 13.5285 2.65461 0.126865 -8.38924 5.57615 -79 1 0.688432 12.6159 5.91845 40.3739 4.73102 13.6953 -80 2 0.965548 12.5027 5.00914 1.60296 -4.44104 -10.7732 -81 2 18.4099 12.7183 5.90627 -44.0147 0.977299 -7.7541 -82 1 5.23962 16.4285 18.4285 2.37714 -1.84876 8.0205 -83 2 5.78786 15.7427 18.0572 3.65919 -12.8888 -12.968 -84 2 5.57695 16.4825 0.678793 -3.22986 7.92557 6.36641 -85 1 0.598604 7.70507 4.14138 -20.7786 -13.2635 7.16681 -86 2 18.6305 8.09263 3.50172 -0.345103 1.12768 -4.13337 -87 2 1.46117 7.8354 3.77399 24.2365 9.84596 -7.22116 -88 1 3.12664 8.94501 6.49467 58.7355 2.96877 -21.5552 -89 2 3.79065 8.46432 7.02112 -12.6266 6.35685 -1.15291 -90 2 2.29097 8.86083 6.88074 -41.9399 -6.12221 23.1652 -91 1 7.26988 10.3368 16.2836 11.5372 -0.463039 -18.2668 -92 2 6.61986 10.5879 15.6307 -2.48374 3.02842 -3.04887 -93 2 6.78814 10.3049 17.1036 -3.00573 -3.18181 16.2709 -94 1 11.123 0.978368 5.0094 -10.4546 8.12706 3.20432 -95 2 11.0717 1.86722 4.62246 7.34447 -2.45893 1.30193 -96 2 10.765 0.419141 4.31729 -2.84542 -7.68945 -6.73121 -97 1 4.36745 2.7997 13.2283 -2.96005 27.1446 -27.16 -98 2 4.67681 3.13482 14.0684 -0.492375 -1.19152 9.60175 -99 2 4.17697 1.87548 13.305 -2.22526 -24.419 13.8486 -100 1 8.37947 10.1962 1.80259 -4.93469 16.4683 -10.3397 -101 2 8.22749 10.8872 2.46356 1.16914 -1.49574 -1.6966 -102 2 8.71062 9.47199 2.30942 8.47484 -21.3721 12.0127 -103 1 10.3811 1.71408 15.5377 20.686 0.359172 -10.6925 -104 2 11.354 1.66546 15.4316 -15.8773 -5.06945 10.6173 -105 2 10.0964 2.02238 14.6685 -5.35844 0.742925 -2.36882 -106 1 2.68357 12.8347 7.81396 4.59418 8.51704 7.17464 -107 2 3.18489 13.5948 7.4697 -3.72618 -6.19027 -0.541735 -108 2 1.90686 12.7457 7.24856 2.42229 -2.05385 -5.50174 -109 1 3.74169 11.6981 5.12659 20.4064 16.2552 5.07347 -110 2 3.6031 10.8525 5.51837 -2.34348 -17.0347 14.1119 -111 2 3.05756 11.7956 4.48632 -17.1397 4.43934 -14.0111 -112 1 6.78306 14.4202 16.945 8.30127 18.455 -2.7408 -113 2 7.70256 14.7228 17.0235 -7.00262 -4.27134 -0.857039 -114 2 6.4289 14.8468 16.1479 2.30915 -9.19793 -2.69046 -115 1 14.2185 14.5268 3.31588 -23.2154 9.18115 10.9982 -116 2 13.6682 15.2954 3.06852 12.5657 -5.26706 1.63848 -117 2 13.7604 14.1667 4.10581 9.83524 -2.33371 -14.8176 -118 1 8.44676 18.1227 16.0393 7.73472 16.3177 -1.68025 -119 2 9.01165 17.3799 16.1525 3.2644 -34.6246 10.2309 -120 2 9.11477 0.14931 15.8801 -4.9724 20.6673 -2.43491 -121 1 4.70679 1.64341 4.91058 -17.3364 -32.3489 41.2122 -122 2 3.86106 2.04855 5.10849 -6.14561 5.35271 -2.51022 -123 2 5.03045 2.1011 4.1778 23.045 28.1017 -39.82 -124 1 14.9769 12.6712 16.4491 28.5182 -25.5733 -37.1858 -125 2 14.5585 13.1664 17.1249 -24.0861 16.0366 17.7329 -126 2 14.4092 12.4828 15.6576 3.30334 14.0855 25.2157 -127 1 15.7195 18.4537 16.8862 -41.4911 -4.79998 -47.5194 -128 2 16.474 18.4695 17.416 41.6971 -5.3201 37.0536 -129 2 15.5173 17.5216 16.6763 -0.165283 4.31671 10.9236 -130 1 1.26675 1.20722 16.5821 1.91531 -3.73727 -7.96899 -131 2 2.06576 1.68562 16.7995 9.77153 8.32265 -0.296149 -132 2 0.695796 1.45596 17.2985 -12.9769 2.74169 12.7471 -133 1 18.1595 4.46894 15.9392 -8.68238 9.49864 15.6389 -134 2 18.21 4.01948 15.1094 2.12602 -9.4702 -15.5502 -135 2 0.321646 4.30297 16.4236 6.52219 -0.344151 0.382064 -136 1 12.2433 16.9631 16.1365 30.1535 25.9085 -42.0202 -137 2 11.4764 16.7912 16.6244 -43.4812 -17.6238 21.6018 -138 2 11.9609 17.1491 15.2014 5.35486 -10.4534 20.1012 -139 1 16.0404 2.55502 18.1172 12.6912 -10.4842 9.42679 -140 2 15.6589 3.39683 18.3503 -6.59057 14.1496 4.33812 -141 2 15.9441 2.46009 17.1755 -7.16214 2.08136 -15.1428 -142 1 6.70635 13.8458 10.192 -16.5385 -19.5662 -16.6234 -143 2 6.46743 13.4829 11.0519 3.62966 4.37567 6.36784 -144 2 6.41781 13.1513 9.56037 11.5929 10.5707 5.5488 -145 1 10.1419 18.3987 2.73425 -19.4638 -25.4286 12.0097 -146 2 10.2073 0.494584 2.15475 6.00155 18.7458 -18.7245 -147 2 9.2799 18.0069 2.48337 13.6051 6.39322 6.25061 -148 1 3.04438 17.7185 6.11283 5.61436 7.93422 -10.0091 -149 2 2.18521 17.5434 5.71014 -2.22655 1.93918 -4.29169 -150 2 3.60431 18.0006 5.35738 -6.06642 -9.44159 14.8188 -151 1 12.59 16.8727 7.99688 3.41749 0.26688 0.968442 -152 2 11.9163 16.1959 7.96054 -9.29683 -10.0995 -8.1817 -153 2 12.3648 17.371 8.78825 5.01363 9.11979 0.25951 -154 1 14.8925 15.2941 8.21002 11.8118 0.190541 -21.4145 -155 2 14.0466 15.7377 8.15471 -7.99071 7.70949 7.81769 -156 2 15.2804 15.4945 7.32486 -0.0803457 -7.85257 22.8773 -157 1 17.7158 18.2428 0.330134 42.1686 22.2301 9.80157 -158 2 18.5718 17.7519 0.320787 -20.6577 0.0591745 -9.59458 -159 2 18.0296 0.514827 0.540707 -19.3386 -19.3229 -5.27308 -160 1 0.848087 10.4587 1.36302 27.1846 51.9138 -28.6855 -161 2 0.125428 9.973 1.66463 -44.0007 -34.6793 17.9508 -162 2 0.450253 11.2027 0.827225 17.544 -22.8417 14.6566 -163 1 1.73752 12.2317 3.35921 -10.6222 -3.23772 -40.3174 -164 2 1.50468 11.5771 2.65039 3.80547 3.73659 24.0112 -165 2 1.78112 13.0447 2.82871 4.93945 -0.670418 11.0651 -166 1 0.61763 17.2312 4.89977 -31.3278 9.09129 49.7394 -167 2 18.753 18.067 4.93438 12.2337 -8.61092 -13.4292 -168 2 0.309388 16.8063 5.75223 19.8395 0.744545 -34.548 -169 1 1.12081 0.925337 9.40389 -12.5044 -10.6635 0.652446 -170 2 1.34187 0.581545 10.2981 -6.32089 4.74016 -12.6461 -171 2 0.253358 0.524348 9.17819 18.5788 9.22491 5.8567 -172 1 16.7331 2.36195 13.2995 -4.07693 -18.6231 24.2357 -173 2 16.9587 2.56306 12.4093 5.05193 8.99127 -27.3142 -174 2 16.5121 1.41005 13.3069 2.86591 9.33714 2.00751 -175 1 2.6752 15.8404 12.084 -17.9655 13.8891 -13.7444 -176 2 3.1007 15.4046 12.7977 10.8605 -10.5552 20.9848 -177 2 3.18035 15.6022 11.2985 0.61387 1.79975 -2.62876 -178 1 16.4324 15.6688 6.07894 -11.0906 -29.1832 8.11987 -179 2 17.3135 15.6699 6.4691 2.82688 3.86386 -3.5648 -180 2 16.3493 16.3586 5.42897 4.86465 16.2346 -9.8305 -181 1 5.78229 5.11191 11.8099 -13.8406 10.2937 3.29755 -182 2 5.26053 5.84491 12.2174 12.8802 -11.8636 -2.84442 -183 2 5.17337 4.36282 11.7377 2.58239 3.92087 3.15374 -184 1 15.1463 4.86734 0.794152 0.864651 12.4924 -33.9562 -185 2 14.9842 4.50309 1.65022 -3.17819 -5.74322 26.2661 -186 2 14.3662 5.39647 0.571272 5.91156 -4.56503 2.45287 -187 1 16.3343 16.3902 2.05204 -8.53913 3.9795 31.3204 -188 2 16.0972 16.7844 2.93864 3.99019 -13.2916 -26.145 -189 2 16.6713 17.1379 1.5654 4.18336 9.27065 -12.2854 -190 1 0.251768 4.84384 3.8243 -5.07672 -49.1083 -0.618349 -191 2 0.303365 5.75864 3.98841 7.12191 44.1717 7.46524 -192 2 0.849427 4.39339 4.43966 -1.76195 8.48948 -7.42491 -193 1 2.97026 15.0637 15.1648 0.961584 14.1925 -19.6325 -194 2 2.86359 14.8338 16.0871 -5.01806 -10.0022 10.5852 -195 2 2.57214 15.9549 15.1104 2.70735 -9.48442 0.706884 -196 1 1.14871 14.6442 9.53518 -42.8529 -19.211 3.24989 -197 2 2.06628 14.849 9.52706 28.3433 -3.949 4.37311 -198 2 1.01023 13.7361 9.90627 12.772 19.4662 -8.86837 -199 1 13.5229 16.5669 11.532 20.3549 -23.4698 16.7524 -200 2 13.3606 17.2446 10.8944 -12.6142 15.9017 -14.8664 -201 2 13.2357 15.729 11.1267 -5.06335 10.0173 1.96475 -202 1 4.64907 1.44855 0.782556 14.1843 16.2277 -15.4645 -203 2 4.13811 2.00007 0.175187 -1.198 1.13782 0.731863 -204 2 4.05002 0.760268 1.05534 -6.36237 -9.04178 10.9284 -205 1 1.45269 18.5669 11.8512 9.08594 -18.5638 20.5671 -206 2 1.3209 0.513151 12.6112 1.192 -1.45307 -0.682323 -207 2 1.82538 17.7349 12.2384 -6.22294 17.2853 -13.4176 -208 1 11.5083 10.14 3.99231 -12.3356 -6.67004 24.2683 -209 2 11.3008 10.4626 3.12291 -1.30093 6.41155 -12.7666 -210 2 12.4624 10.1697 4.04844 12.7044 -2.53047 3.95194 -211 1 8.22637 12.1595 3.70182 22.1984 -6.43536 -24.1249 -212 2 9.06359 12.543 3.994 2.39995 3.52197 1.898 -213 2 7.64229 12.2644 4.4292 -22.7553 4.87752 31.4773 -214 1 14.5041 4.04055 3.28708 -18.3332 1.47774 -0.327682 -215 2 14.9873 3.94029 4.11097 10.9182 2.80533 4.02706 -216 2 13.7169 4.55783 3.53097 2.05743 -3.46177 -0.871318 -217 1 5.62743 1.64825 7.52429 33.006 28.3977 -54.9531 -218 2 5.01294 1.12929 7.98513 -35.2623 -28.0367 23.7041 -219 2 5.43705 1.49837 6.5464 4.70081 6.15592 32.4881 -220 1 17.8649 1.10253 4.84999 -3.85271 -3.04411 9.89583 -221 2 18.5316 1.48406 4.28754 10.0589 0.579138 -13.4652 -222 2 17.9089 1.63153 5.65146 -2.44801 0.268727 5.2117 -223 1 6.82865 9.41118 4.50161 13.9732 -1.80028 18.7676 -224 2 6.94383 9.68391 5.43824 -8.65407 -5.40133 -16.2957 -225 2 7.70845 9.07477 4.25578 -5.27921 1.965 -0.840285 -226 1 2.66065 14.8943 1.98186 -2.57221 -9.24308 25.7982 -227 2 3.31586 14.7955 2.69868 -8.68087 -2.61777 -7.29774 -228 2 3.12007 15.367 1.30687 7.03004 7.53846 -18.6884 -229 1 17.3318 12.9277 13.2024 14.566 -8.41998 -6.98679 -230 2 16.4646 13.2932 13.3909 -3.11164 10.4066 0.365823 -231 2 17.9245 13.6681 12.9725 -15.6789 -3.68206 1.74475 -232 1 14.9332 10.5631 1.42248 26.9386 23.5346 15.1493 -233 2 15.5074 11.3103 1.7869 -22.4798 -24.8917 -12.2482 -234 2 14.0193 10.8096 1.5708 -2.19259 1.9486 -0.294463 -235 1 5.71089 6.73608 4.5629 -4.22281 28.118 -3.03355 -236 2 5.94827 7.69445 4.64343 -4.82413 -18.183 -7.3163 -237 2 6.31292 6.28304 5.16113 4.14578 -2.25186 0.1588 -238 1 7.97883 8.3192 10.3001 7.8407 -5.86676 -34.7961 -239 2 8.53275 9.01778 9.91692 4.61581 1.53144 9.76809 -240 2 7.67805 7.86001 9.48783 -4.88471 -0.599295 18.8237 -241 1 13.4226 18.4487 5.72909 4.08913 1.21656 -6.98532 -242 2 12.585 0.250804 5.52036 7.76092 4.80861 -0.84516 -243 2 13.2097 17.9386 6.50687 -2.642 -10.6174 11.5339 -244 1 0.0869602 2.62265 0.223952 -9.8031 -15.3274 -6.51765 -245 2 17.9117 2.88521 18.4333 -9.97249 -6.92357 5.22107 -246 2 0.604672 3.41479 0.198655 20.2406 16.0872 6.75582 -247 1 12.7806 11.0275 9.75202 47.836 -29.2198 23.6504 -248 2 11.892 10.9606 9.4924 -44.5823 -3.62186 -10.7645 -249 2 12.9839 10.1194 10.1272 -4.83434 23.2951 -13.1663 -250 1 0.705171 12.1501 11.0469 -11.5221 2.5881 -10.739 -251 2 18.3743 12.1368 11.1638 13.8029 4.27958 5.25964 -252 2 1.13401 12.4861 11.8379 -3.00537 2.27024 12.2218 -253 1 5.1174 7.31342 13.4172 11.1181 3.69095 0.765545 -254 2 5.61979 7.99643 12.9358 -2.94992 -2.73128 4.30069 -255 2 5.6521 7.15272 14.218 -5.77355 -1.15348 -7.33249 -256 1 1.197 6.86571 11.8595 38.3077 26.916 14.5555 -257 2 0.451078 7.27927 11.4324 -8.7071 4.85333 -5.01967 -258 2 1.83731 7.62187 12.0983 -31.0022 -32.2106 -6.42275 -259 1 15.4885 9.63727 12.3206 16.478 -29.8614 -10.1392 -260 2 15.1661 10.5006 12.1398 -12.0715 29.4427 -0.903292 -261 2 15.2587 9.41843 13.2151 -2.74274 1.51694 14.7591 -262 1 16.5678 12.6919 5.49509 2.68502 5.28083 21.2685 -263 2 16.324 13.6184 5.59953 -0.326156 6.48336 2.9395 -264 2 16.4016 12.5196 4.57887 -2.84479 -5.20052 -25.0662 -265 1 6.28213 9.87258 0.0490999 16.8985 1.83912 15.6964 -266 2 5.56262 10.3905 0.421328 -3.89363 2.12479 6.12138 -267 2 7.01982 9.90555 0.722608 -19.7924 2.8001 -17.1777 -268 1 12.2865 6.1036 4.06304 19.2748 24.5544 -29.5048 -269 2 12.3306 6.8161 3.36437 1.4085 -17.3408 22.8012 -270 2 11.3814 5.83426 4.0192 -21.2841 -11.2083 4.33393 -271 1 0.298047 12.7955 0.166375 -3.43648 3.64279 0.0778505 -272 2 -0.0290314 13.4316 0.817326 3.1389 2.62115 2.93426 -273 2 18.4391 12.9788 18.0124 -4.25126 3.67416 -7.60949 -274 1 3.647 18.6117 8.59889 -15.5834 11.8668 6.1299 -275 2 3.50703 18.267 7.70639 0.18727 -3.89186 2.0216 -276 2 2.76186 0.338497 8.83167 17.7751 -6.65964 -2.12733 -277 1 7.50606 17.376 4.49824 -10.0508 -46.4512 11.7168 -278 2 7.49016 18.3059 4.51667 7.03352 43.591 -0.815572 -279 2 7.72157 17.1186 3.60818 -1.05523 3.68228 -12.2984 -280 1 9.25162 17.1195 12.2401 -20.7119 -1.17481 -13.1138 -281 2 9.34873 16.3083 11.723 0.965197 -1.09758 -0.258815 -282 2 10.0653 17.2534 12.7074 19.1017 -2.42392 11.5163 -283 1 13.35 12.9891 7.98546 26.3101 20.7404 -8.62941 -284 2 13.4089 12.1901 8.49273 -4.66259 -15.0904 10.7497 -285 2 14.2093 13.4501 8.17144 -24.2961 -0.252284 -5.87391 -286 1 14.9018 2.99422 15.3537 -18.6075 -8.06583 14.6174 -287 2 14.2375 2.30647 15.2045 2.81445 1.4476 3.5012 -288 2 15.4631 2.94521 14.5905 14.0528 3.89371 -13.7736 -289 1 9.86333 15.5824 16.9775 -1.70109 -0.0675876 9.27141 -290 2 10.3396 14.7637 16.7526 0.856458 3.65656 -1.57854 -291 2 9.55317 15.4797 17.8978 1.12056 -0.962034 -11.839 -292 1 11.2957 8.40029 16.577 -16.0633 -20.1101 7.86553 -293 2 10.6817 7.8482 16.0424 7.68237 12.4971 4.88138 -294 2 11.3251 7.92133 17.4322 4.78934 8.39937 -13.6138 -295 1 3.89281 18.1695 16.7848 -3.14598 -18.8551 -14.8366 -296 2 4.41813 17.5168 17.2844 -2.97968 13.5676 2.86087 -297 2 3.87713 0.360621 17.2331 6.32956 9.89438 13.0847 -298 1 2.18947 4.17934 8.91366 -18.0693 4.35017 -17.8699 -299 2 3.09766 4.08917 8.6846 23.1764 -2.78898 -7.58361 -300 2 2.16493 4.06394 9.84833 -5.05649 -4.17918 28.8808 -301 1 9.87375 10.372 9.69798 10.3489 -25.1121 17.1783 -302 2 9.47622 11.1704 9.40878 -10.9495 28.2307 -13.2887 -303 2 10.0218 10.4724 10.6474 2.61027 -3.39635 1.23761 -304 1 9.66501 0.904023 10.8717 -13.0386 -22.5074 -9.87351 -305 2 9.3051 0.0213231 11.0865 8.01248 8.88818 8.11202 -306 2 9.06191 1.19139 10.169 9.00305 9.82525 0.172013 -307 1 9.18563 15.0903 10.2115 17.1556 13.6164 1.72702 -308 2 8.73275 15.8289 9.78742 -0.477718 6.62954 -2.89772 -309 2 8.53792 14.3995 10.1946 -15.8858 -12.7719 2.13472 -310 1 0.946133 9.58267 10.2797 -17.999 7.07835 7.04569 -311 2 0.977457 10.4775 10.6382 -6.96742 -0.068666 -4.76802 -312 2 1.85682 9.38261 10.1843 21.4216 -13.3352 -8.00245 -313 1 16.9414 4.83421 8.13223 15.4014 12.0295 -27.8426 -314 2 16.4342 5.57084 8.44793 -11.0978 12.5109 2.31217 -315 2 16.8158 4.17203 8.77314 -2.49922 -25.6846 24.7871 -316 1 14.7535 14.7061 0.203986 15.073 4.98951 -2.11802 -317 2 15.1043 15.2916 0.890887 3.3452 -1.27018 2.88153 -318 2 13.9621 14.3164 0.552408 -18.4772 -7.94901 9.40987 -319 1 3.67958 11.0243 9.53991 2.98139 -0.929731 17.0732 -320 2 3.55398 11.294 10.4695 5.20942 3.18167 -4.3207 -321 2 3.23108 11.6955 9.00414 -3.72853 0.365488 -5.84942 -322 1 11.2021 10.759 1.44219 -17.3262 -13.0718 -7.65614 -323 2 11.58 11.5828 1.16251 10.55 19.7497 -9.01804 -324 2 10.309 10.7579 1.05212 6.07305 -2.69648 6.21388 -325 1 13.1662 7.17502 12.7531 25.9391 -3.29657 1.887 -326 2 14.1362 6.96154 12.7671 -19.0435 5.16748 0.470499 -327 2 12.7272 6.32599 12.8606 -4.03684 -6.30893 0.442018 -328 1 9.61497 1.86018 0.978015 -9.58691 9.0933 -29.7593 -329 2 8.82052 1.59363 0.443821 14.7013 3.9795 16.3864 -330 2 10.1598 2.41617 0.376969 -4.12787 -12.2318 8.97473 -331 1 10.6544 13.5231 4.58863 -13.6132 -6.73185 -2.44549 -332 2 11.4017 12.9559 4.77554 12.969 -5.04099 -4.5155 -333 2 10.624 14.0848 5.36102 -2.93668 8.13722 11.8558 -334 1 14.451 1.77042 10.9566 -5.06993 -21.3108 1.92478 -335 2 15.2282 1.34301 10.5576 -2.05514 6.77792 0.416034 -336 2 14.5487 2.7176 10.8324 3.84606 4.21375 0.609558 -337 1 14.5616 12.2019 11.6619 17.6804 1.81894 22.1071 -338 2 15.3038 12.427 11.1092 19.6924 5.46932 -2.69443 -339 2 13.8862 12.1117 11.0284 -35.3643 -9.54852 -21.0379 -340 1 8.20666 5.07147 9.84086 19.0973 -30.0877 -21.2342 -341 2 7.45963 5.1784 10.3955 -25.2729 10.7477 18.5337 -342 2 8.15765 4.10536 9.6198 7.47394 24.0469 -0.436218 -343 1 1.5637 16.9015 18.3956 -12.4387 -25.8837 12.5929 -344 2 2.10927 17.2609 17.7108 10.7809 10.3745 -20.1818 -345 2 1.47705 15.9462 18.1578 7.28008 19.3441 8.23831 -346 1 1.51254 17.2865 15.33 -55.1424 19.1245 13.5119 -347 2 1.44158 18.2256 15.6397 11.4216 -23.3977 -5.64032 -348 2 0.55797 16.9673 15.4072 37.0312 4.44622 -8.61518 -349 1 3.63692 5.75726 6.07961 7.7365 -18.3794 -8.43759 -350 2 3.1745 6.31944 6.69962 -9.61621 11.1355 4.40451 -351 2 4.08899 6.28836 5.40075 -0.121738 1.87808 9.22135 -352 1 12.4625 9.47055 14.2033 -9.88788 31.7301 7.89028 -353 2 12.9131 8.72585 13.8435 10.9703 -26.4307 -11.7769 -354 2 12.2412 9.2145 15.1039 -0.841012 -4.82452 5.58465 -355 1 4.05279 15.2823 6.91192 -35.0907 -10.5097 14.3913 -356 2 3.49702 16.0377 6.67476 5.8423 0.670453 -1.17602 -357 2 4.92638 15.5321 6.67665 32.7349 8.37925 -5.72993 -358 1 0.666426 8.62945 15.01 -4.81633 6.31993 2.8284 -359 2 0.390025 9.55783 15.0778 2.6081 -0.187855 1.05312 -360 2 1.36445 8.64555 14.3512 6.1817 -1.74341 -6.99991 -361 1 12.9834 8.27358 10.2916 -19.5051 6.59204 10.6567 -362 2 13.6375 7.73399 9.85191 12.7638 -5.94229 -3.5145 -363 2 12.8815 7.86968 11.1799 4.96282 8.38227 -11.7258 -364 1 15.3269 7.75333 3.56288 29.5219 38.2257 -22.8776 -365 2 14.5855 7.35684 3.13467 -21.9298 -17.371 4.59449 -366 2 15.5403 7.50003 4.45743 -10.8574 -16.6026 13.017 -367 1 17.2887 6.69393 0.021468 15.5778 -19.6292 8.74644 -368 2 16.7574 5.92192 0.248673 1.14134 -1.83764 1.32773 -369 2 16.6558 7.32534 18.3698 -22.9594 20.3863 -6.57681 -370 1 8.86981 6.94597 7.81474 24.2415 27.8548 -9.55577 -371 2 9.77577 7.36617 7.90295 -24.2622 -15.8521 -2.69303 -372 2 8.7837 6.29392 8.50186 -0.35036 -13.7271 19.3897 -373 1 12.3819 0.576227 1.23609 4.50683 -3.19553 -2.96149 -374 2 13.3476 0.534404 1.26268 -2.04299 5.45052 6.49319 -375 2 12.129 0.50298 0.316799 -1.00379 -2.5807 -2.54403 -376 1 5.62478 15.1294 14.5559 -8.95515 -20.8805 6.21096 -377 2 4.66749 15.251 14.733 11.0075 0.339747 -2.61971 -378 2 5.99586 15.9305 14.1948 2.79164 18.0184 -3.26028 -379 1 3.86891 6.41255 1.75203 -0.0773217 -5.81596 13.5476 -380 2 3.55695 7.28194 1.50076 -6.60469 12.2107 -8.14743 -381 2 4.09127 6.52195 2.68979 -0.816275 -1.80663 -6.76426 -382 1 3.9342 11.5843 12.3776 -18.6931 -4.72392 -0.912594 -383 2 4.79227 12.0122 12.4616 2.30575 0.246561 2.78418 -384 2 3.29871 12.1178 12.8946 9.72132 -5.51488 -9.32366 -385 1 5.32882 3.8676 15.8786 0.594801 -80.2026 -15.123 -386 2 6.00417 3.18473 15.5574 -21.0433 25.388 14.8589 -387 2 5.72544 4.69544 15.8213 26.1638 51.9163 -2.72297 -388 1 14.3304 10.2034 4.48175 -27.4096 24.8129 53.7077 -389 2 14.5884 9.79586 5.33863 -8.33179 4.59428 -12.4543 -390 2 14.8538 9.80174 3.84099 29.6706 -27.6476 -38.9945 -391 1 7.77951 17.4021 9.16969 8.83259 -7.31352 -4.45478 -392 2 6.90706 17.6601 9.4324 -15.0276 -0.0996042 12.8709 -393 2 7.95009 17.9588 8.40488 9.49987 1.3194 -6.72214 -394 1 4.51552 14.5162 3.99356 4.98181 -4.90212 -22.3913 -395 2 4.52626 15.4247 4.27156 -0.518589 17.7617 2.00307 -396 2 4.31207 14.0204 4.77138 -3.57212 -17.3619 18.7252 -397 1 14.1875 7.4375 15.7998 -22.901 -10.8896 -16.0938 -398 2 15.1146 7.35808 15.6286 24.9688 -1.25651 -4.60954 -399 2 14.1131 7.89225 16.6248 1.32628 8.65776 19.0596 -400 1 2.98527 18.3068 1.9119 -4.72699 -30.9822 -37.1172 -401 2 2.49826 17.7826 1.20191 12.7581 13.6458 27.4428 -402 2 2.34371 0.225349 2.32895 -15.9948 14.8465 9.72817 -403 1 8.01181 1.59883 4.56348 -29.7821 5.07108 -10.5683 -404 2 7.46781 2.03632 3.88017 -2.37558 -3.45248 10.775 -405 2 8.87859 1.65459 4.20584 24.9106 -1.40589 -4.13938 -406 1 2.43696 14.1424 17.6778 32.6678 8.55365 0.150748 -407 2 1.74447 13.6484 18.0869 -17.757 -15.5673 8.49591 -408 2 3.25626 13.7213 18.0204 -5.64692 6.54589 -2.94203 -409 1 0.856601 1.76819 13.8909 -34.0133 7.6587 12.0684 -410 2 0.79549 1.64555 14.8654 10.1884 -1.39389 -18.6264 -411 2 18.5699 1.97567 13.6249 24.5068 -3.80874 6.24474 -412 1 4.3972 0.0813689 13.9033 -13.8751 0.78744 16.7708 -413 2 5.2251 18.2898 13.7459 20.8939 -4.75733 -3.28132 -414 2 4.21678 18.5292 14.8441 -3.95615 2.50922 -10.6456 -415 1 7.163 0.723926 18.3524 28.8431 -20.8152 -22.3389 -416 2 7.29578 0.265373 17.4701 -6.89821 16.5948 25.8874 -417 2 6.28988 1.09447 18.4079 -18.4483 2.86302 0.00697782 -418 1 16.0461 18.4126 13.9592 23.9709 4.87143 24.0859 -419 2 15.127 18.3862 13.8391 -39.1169 -4.38354 -15.9017 -420 2 16.1011 18.5404 14.9193 8.5862 0.360016 -3.75437 -421 1 10.1416 4.5234 16.2814 33.6533 37.5162 -8.59515 -422 2 11.1148 4.69187 16.0483 -33.0569 -13.9639 15.4314 -423 2 9.96481 3.59397 16.253 2.9151 -23.0089 -4.34536 -424 1 15.9284 17.7644 4.42623 32.451 -11.9188 -9.4973 -425 2 16.5348 -0.134683 4.55752 -3.00893 1.73986 -2.0661 -426 2 15.0985 18.0471 4.75447 -36.3204 13.6328 11.8833 -427 1 7.01478 17.4412 13.8546 -37.2955 -8.85564 -21.6385 -428 2 7.52749 17.7553 14.5758 15.4879 9.12118 24.9138 -429 2 7.64547 17.2338 13.1683 11.7367 1.38126 -7.54157 -430 1 13.2517 6.48941 6.59541 21.6379 18.6409 -4.45059 -431 2 14.0732 7.02646 6.4901 -17.572 -15.5204 8.29538 -432 2 12.9904 6.33391 5.6816 -8.39128 -3.46546 0.217322 -433 1 7.82903 2.34082 9.30706 0.848413 1.46751 38.8479 -434 2 7.32489 2.17899 10.1397 9.78087 5.93227 -12.3925 -435 2 7.21411 2.12937 8.62642 -15.7826 -8.09866 -24.9258 -436 1 15.1931 14.7992 13.6996 5.60594 -14.9485 0.236255 -437 2 14.8724 15.0774 14.5533 -1.16755 2.2837 13.7936 -438 2 15.0044 15.5062 13.0994 -6.5851 10.7381 -11.5383 -439 1 9.39722 8.31385 3.80437 -4.07127 17.2834 -4.44624 -440 2 10.2713 8.68973 4.00761 -3.0526 -2.08627 -0.470344 -441 2 9.46128 7.36215 3.86627 5.27028 -8.92187 3.93672 -442 1 17.7859 13.5845 16.3834 -19.0466 -29.0207 18.2461 -443 2 16.8295 13.3731 16.3512 7.31415 3.8698 0.00611806 -444 2 17.8697 14.4051 15.917 1.12921 18.7325 -11.1152 -445 1 4.94376 10.5922 2.82245 -18.0715 22.8685 -14.9529 -446 2 5.66076 10.3167 3.37377 16.0421 -11.7082 13.1735 -447 2 4.72943 11.4907 3.12728 0.871258 -13.2337 -1.99455 -448 1 3.75648 8.36099 10.0882 -2.83158 17.8244 -9.78689 -449 2 3.88314 9.30809 9.8443 -3.15161 -16.2727 -0.870444 -450 2 3.74879 8.36585 11.0419 0.849549 -1.60464 13.0402 -451 1 15.9818 6.99244 6.07768 -13.3688 18.7296 1.03973 -452 2 16.7792 7.41732 6.38792 13.9106 3.61693 3.9934 -453 2 16.2026 6.08994 5.88298 6.53831 -20.9898 -2.75314 -454 1 15.1161 7.11481 9.04764 0.565665 -31.7989 38.5144 -455 2 15.8028 7.45918 9.62834 5.57768 4.61323 -0.34974 -456 2 15.1416 7.62578 8.27782 1.5606 28.4329 -39.6698 -457 1 6.26636 12.9592 12.746 15.2088 -10.2167 -2.30532 -458 2 7.09456 12.5046 12.9751 -5.12301 -5.10662 -0.512627 -459 2 6.13107 13.5604 13.4742 -6.25916 17.1748 9.55337 -460 1 12.1295 4.51914 13.098 -40.0586 -31.7334 -0.542355 -461 2 12.3128 4.55827 14.0372 7.66008 7.87672 6.17129 -462 2 11.3118 3.91999 13.0515 32.2373 26.2449 -7.62055 -463 1 11.3854 8.14886 7.92202 -18.4022 6.94815 -10.6415 -464 2 11.9487 7.53516 7.44565 12.5498 -6.92106 -4.31871 -465 2 11.7891 8.26504 8.77918 7.07043 -0.608458 13.7447 -466 1 17.1486 10.8722 7.52372 -29.3422 15.2924 19.4167 -467 2 17.741 10.1746 7.28593 21.144 -15.6164 -13.9006 -468 2 16.9754 11.4691 6.78151 4.60435 -5.53137 -7.06809 -469 1 5.26553 18.1239 10.9774 20.3802 -2.13667 -3.01104 -470 2 4.75345 17.8709 11.7323 -12.4512 -5.88679 12.7575 -471 2 4.64325 18.2391 10.2688 -13.5246 2.23536 -17.92 -472 1 7.60715 17.4884 1.7834 -2.49749 -8.82149 -34.1915 -473 2 7.92668 16.7242 1.2322 -11.5566 19.54 16.0619 -474 2 7.18999 18.106 1.13139 15.7932 -7.79309 14.6318 -475 1 1.92845 12.8983 13.5911 -4.1829 -6.61346 -8.43532 -476 2 1.49445 12.3761 14.2737 -4.42561 -3.96966 1.7572 -477 2 2.30088 13.6477 14.0465 3.83448 15.9215 12.3791 -478 1 9.57624 6.80131 14.8487 2.82943 -31.3701 -0.177857 -479 2 9.74438 5.86263 15.1368 -4.04832 25.5486 -0.431769 -480 2 9.80341 6.81631 13.907 0.113844 6.0265 -0.426062 -481 1 15.2789 4.31862 10.7553 12.937 12.8557 31.6205 -482 2 16.1415 3.96953 11.0436 -5.39931 0.983411 -21.2391 -483 2 15.1479 4.98349 11.4601 -8.5537 -3.88808 -14.9921 -484 1 11.2581 6.18474 0.159508 31.1076 25.8623 9.85053 -485 2 11.549 5.31982 18.5294 -8.46095 -20.0483 -6.31791 -486 2 10.3153 6.29854 0.132928 -17.8901 -6.88616 -7.00405 -487 1 -0.015613 11.3989 15.0155 5.52071 0.0143375 15.3818 -488 2 18.1286 11.6803 14.2478 -6.84029 3.18322 -8.47428 -489 2 -0.24984 12.0811 15.6717 7.42423 -4.02873 -7.86488 -490 1 7.04792 9.26093 7.28081 24.8295 12.5521 -3.74072 -491 2 6.59027 8.49663 7.6071 -13.7147 -18.0719 7.78469 -492 2 7.98742 9.01504 7.31689 -8.33941 1.9664 -1.88331 -493 1 18.3308 15.3469 12.3202 -6.03602 -2.26652 6.8961 -494 2 0.60478 15.4762 12.0772 12.6515 4.5696 -6.24084 -495 2 17.7927 15.7945 11.6538 0.941578 1.81095 -5.33876 -496 1 16.5149 4.38922 5.26132 -0.591505 19.7601 -54.4807 -497 2 16.8056 3.98806 6.0517 15.8153 -15.5532 32.6352 -498 2 17.2724 4.45951 4.61195 -16.46 -3.71476 24.2381 -499 1 17.705 3.15738 10.7395 -3.58994 -28.0349 -4.43916 -500 2 -0.0357658 3.31586 11.0143 13.799 7.93723 3.46651 -501 2 17.7252 2.25587 10.3433 -5.09014 14.337 3.42017 -502 1 12.282 -0.0102014 10.1171 1.80463 -26.6374 -6.99772 -503 2 11.3739 0.250254 10.2263 -16.4794 9.03176 6.86793 -504 2 12.791 0.759276 10.3145 17.2573 22.9944 3.87451 -505 1 10.3906 9.77529 12.4736 -11.6246 -18.6488 -11.2601 -506 2 11.1162 9.76462 13.0993 9.33947 3.77576 6.26492 -507 2 10.2448 8.81959 12.3007 0.540403 13.8663 1.27912 -508 1 0.620737 2.80838 7.04076 1.85552 -26.9198 -9.07562 -509 2 0.56001 3.58776 7.58035 -0.0658531 10.9425 14.6075 -510 2 1.10446 2.13014 7.5549 -9.15748 13.0523 1.42789 -511 1 0.330306 15.2957 6.90187 -7.34135 39.0889 57.248 -512 2 0.64916 14.9551 7.78023 -6.58887 6.78122 -17.5325 -513 2 0.549392 14.6745 6.26262 18.9985 -47.7984 -33.3782 -514 1 17.0475 6.9988 15.1595 3.61332 2.27156 3.35689 -515 2 17.7695 7.63103 15.0486 -1.58895 3.22527 -3.41358 -516 2 17.4554 6.32111 15.7084 -3.97121 -9.30147 -1.03946 -517 1 9.1229 12.4841 8.04245 42.4716 -17.0961 -6.2748 -518 2 9.3803 11.751 7.44403 8.89783 14.9312 6.88846 -519 2 8.20686 12.4452 7.97952 -55.5673 6.80073 1.54221 -520 1 1.25348 1.79037 2.92813 -6.45569 8.99744 5.64127 -521 2 0.618969 2.05555 2.26044 -0.811293 0.804254 -10.1384 -522 2 1.53437 2.62736 3.32834 8.32683 -8.65344 1.50874 -523 1 4.08283 15.132 9.84955 18.6585 -7.67887 -4.13383 -524 2 4.13303 15.3467 8.91064 -4.64689 1.73023 -5.13685 -525 2 4.95775 14.7288 10.0227 -10.2431 6.10486 1.39562 -526 1 7.30601 2.19422 14.6517 -6.95706 -8.0865 3.71032 -527 2 7.17746 1.61632 13.8834 -0.940722 6.01065 3.73041 -528 2 7.50104 3.06853 14.3169 9.18921 6.42869 -7.97623 -529 1 18.506 14.6308 2.17255 -30.1365 -0.614545 -1.61255 -530 2 0.727688 15.0378 2.26332 7.05 8.92743 1.17189 -531 2 17.7886 15.3173 2.20949 19.3309 -8.24877 -2.15246 -532 1 9.97566 2.72581 12.9114 -11.2099 12.673 12.9937 -533 2 9.86165 2.06107 12.2382 3.86591 -12.7401 -14.4562 -534 2 9.16654 3.26167 12.8314 9.11555 0.77907 4.27596 -535 1 2.93178 8.92582 13.081 1.70152 2.66119 1.53014 -536 2 3.14805 9.86555 12.9479 4.31652 -6.20308 -1.56758 -537 2 3.73073 8.51399 13.4597 -8.92719 0.122715 -5.32652 -538 1 3.2497 8.49808 3.73135 7.7637 26.6897 -66.399 -539 2 3.59457 9.35475 3.3251 -8.07179 -35.8245 7.88572 -540 2 3.32757 8.66083 4.63283 0.688531 4.50937 55.9505 -541 1 5.66796 7.21231 8.59238 -0.641232 -8.3741 -2.33168 -542 2 5.55885 6.25431 8.52804 10.6614 2.37054 -1.78385 -543 2 4.98671 7.4468 9.22816 0.961703 9.61661 1.51464 -544 1 14.8738 1.42122 1.93778 -12.939 -8.09002 14.9013 -545 2 14.5066 2.19936 2.41013 13.5309 -5.26917 -12.7438 -546 2 15.3961 1.64306 1.16722 2.80937 13.5796 -4.98575 -547 1 8.4154 15.1394 0.773463 -1.23857 3.93157 -9.75401 -548 2 9.15191 15.1483 1.39458 4.79594 -7.97678 6.77178 -549 2 7.72939 14.5584 1.13871 1.01453 -0.106788 3.48853 -550 1 15.5631 1.364 7.19799 20.5383 14.1474 18.9399 -551 2 14.9704 0.811359 6.72127 -20.082 -15.4085 -14.9718 -552 2 15.0111 2.04928 7.59859 -2.39038 6.78983 -5.63995 -553 1 5.04086 13.0229 18.4653 -16.526 -4.40388 -18.1368 -554 2 5.51186 13.0765 0.64315 8.46246 3.02378 17.117 -555 2 5.66208 13.3388 17.7987 -1.33855 -1.44241 4.73678 -556 1 15.3891 8.54048 18.1286 -6.10206 -9.0298 20.9903 -557 2 15.6702 9.06907 17.396 9.32842 15.5064 -17.6225 -558 2 15.3407 9.15597 0.239346 -3.25407 -2.5962 -5.00154 -559 1 12.0788 3.07289 18.3192 12.549 -10.6185 1.49283 -560 2 12.5729 2.60825 0.359083 -9.10594 9.02489 11.6275 -561 2 12.4194 2.60778 17.5512 -7.87867 2.96301 -9.52933 -562 1 13.1665 12.6793 5.14706 7.93439 -3.9476 12.1924 -563 2 13.7696 11.9755 4.86963 -4.91093 -2.83846 -5.3825 -564 2 13.2489 12.6724 6.11347 -1.2685 5.53825 -1.32442 -565 1 6.04116 7.20215 0.12064 7.04453 6.18255 -12.3628 -566 2 5.83851 8.12748 -0.154348 1.72696 -16.7644 14.2262 -567 2 5.20617 6.73813 0.252386 -0.898724 4.83199 2.26117 -568 1 17.6547 15.8889 14.9543 35.0528 -4.14946 21.8068 -569 2 16.7907 16.2722 15.0644 -14.9966 1.76464 -15.1201 -570 2 17.9353 15.7106 14.0428 -17.4402 7.26196 -6.43436 -571 1 13.1733 0.917277 16.6395 -12.3557 8.76343 2.76166 -572 2 14.0527 0.785776 16.9891 12.1183 -2.33791 -0.0845054 -573 2 12.8033 0.0287439 16.599 0.155899 -2.85039 -4.8341 -574 1 10.9713 14.5555 7.36537 -14.2255 -14.9035 9.86762 -575 2 10.1709 14.1495 7.79489 23.622 7.7433 -12.5051 -576 2 11.716 13.9517 7.54396 -5.74804 5.50666 -0.0050929 -577 1 17.5337 8.50243 2.08938 -5.40396 -31.7286 -5.54565 -578 2 16.6651 8.377 2.51924 11.1588 5.07358 -2.60802 -579 2 17.6234 7.66639 1.54889 -0.0314299 30.6214 9.39113 -580 1 12.3599 7.90174 1.98937 3.23567 -16.3128 -6.49447 -581 2 11.7961 8.65526 1.85661 -2.62113 17.411 2.96359 -582 2 12.056 7.28247 1.30894 3.22552 -0.339632 3.88847 -583 1 11.9987 14.6627 10.3756 12.942 21.9862 15.1728 -584 2 12.1481 13.8459 9.95801 9.02096 -31.6093 -18.7525 -585 2 11.0572 14.7574 10.3761 -24.4084 6.55121 -1.49817 -586 1 6.83545 6.97591 15.5496 -11.1581 -18.4558 -7.96595 -587 2 7.75433 6.91064 15.3306 20.697 -3.79434 -9.10488 -588 2 6.829 7.75126 16.0755 -7.29309 23.7102 19.2635 -589 1 8.01446 4.61093 13.3684 -42.1501 -10.3174 -21.1074 -590 2 7.18404 4.82769 12.8493 26.4504 -9.34552 12.0218 -591 2 8.34807 5.45326 13.6307 9.05324 16.4922 6.04122 -592 1 13.4266 12.1814 14.3212 -6.42777 -0.785601 -11.9683 -593 2 13.0158 11.3184 14.1828 2.17743 -6.12306 4.21948 -594 2 13.8675 12.3621 13.4761 -0.124998 4.48227 1.48561 -595 1 14.6825 9.43166 7.27492 9.85972 28.3832 27.9741 -596 2 15.5174 9.92891 7.46534 -14.0141 -13.1604 -8.13985 -597 2 14.0576 9.79435 7.94424 7.51867 -12.8522 -19.303 -598 1 12.7091 16.9592 3.18265 16.188 -54.3303 -7.24671 -599 2 12.7269 17.2341 4.07879 2.36138 14.6014 27.6129 -600 2 12.279 17.6213 2.6979 -21.2589 39.1636 -23.5451 -601 1 1.03636 7.13727 17.3765 4.75158 -4.20474 15.7377 -602 2 0.172257 7.41544 17.719 4.25282 -10.0113 -2.57097 -603 2 1.1139 7.5113 16.5007 -3.03142 8.85376 -8.54904 -604 1 12.882 5.00728 15.6915 -13.3168 2.35737 2.40623 -605 2 13.5933 4.38686 15.8029 14.6532 -13.0711 -0.480408 -606 2 13.3236 5.8608 15.7721 -0.35756 9.80313 -2.71263 -607 1 2.42233 3.36085 5.14652 -1.4819 -20.4954 -28.2661 -608 2 1.78479 3.2289 5.83557 -10.283 -5.3637 15.3955 -609 2 2.79623 4.21009 5.29825 15.429 26.5106 10.9541 -610 1 8.29403 11.1124 13.578 -10.7346 17.3121 -71.8204 -611 2 8.44225 10.8317 14.4188 2.94407 -17.9634 86.1576 -612 2 9.02074 10.6663 13.1421 6.44484 1.50589 -14.4967 -613 1 12.9406 1.47026 13.2897 0.354478 -37.8914 22.4103 -614 2 13.6523 1.40022 12.6671 11.2026 2.70228 -18.849 -615 2 12.6313 2.34545 13.2159 -11.96 35.388 -6.53093 -616 1 6.51021 13.5896 2.17003 14.8824 -7.80817 -21.2989 -617 2 5.87965 13.8406 2.83705 -10.6705 6.78718 16.3658 -618 2 7.14425 12.9838 2.58896 -6.69863 7.51381 1.45504 -619 1 15.9112 6.50963 12.6885 16.1371 8.47906 -9.98075 -620 2 16.4229 7.02402 12.0187 -10.4906 -13.771 14.0264 -621 2 16.4535 6.54884 13.5054 -11.4677 1.21509 -6.34034 -622 1 16.8027 0.705691 9.58115 1.1294 19.8318 -8.72086 -623 2 16.927 18.412 9.70296 -4.50862 -18.5326 4.35013 -624 2 16.4766 0.834017 8.66778 -1.09927 -3.21438 5.98018 -625 1 6.10776 11.6244 8.30817 -7.08025 31.3016 10.3571 -626 2 5.31117 11.3633 8.78813 -2.85933 -0.839224 -1.79107 -627 2 6.50869 10.8152 8.04097 10.2317 -24.1838 -9.43106 -628 1 2.82434 8.71866 0.367104 27.0695 8.27339 20.5452 -629 2 2.22535 8.20379 18.5266 -22.1964 -28.7808 -30.261 -630 2 2.24775 9.38106 0.731441 -2.19807 14.7641 10.188 -631 1 10.1092 10.4559 6.56308 -0.703462 -11.3062 5.02538 -632 2 10.4957 9.70218 7.03882 1.80116 3.11275 -0.176711 -633 2 10.5447 10.4553 5.70619 3.2422 0.610478 -8.25928 -634 1 6.77867 15.7679 6.62657 -1.68281 -11.8864 -9.65654 -635 2 7.19346 15.995 7.46341 4.74707 6.17504 0.549944 -636 2 7.26738 16.2069 5.90636 -4.84487 7.71134 8.89334 -637 1 6.4599 12.9833 5.69613 7.9309 12.6721 2.99822 -638 2 6.6611 13.9194 5.88765 -3.42976 -10.7335 1.27405 -639 2 6.10779 12.6203 6.51977 -0.735551 -2.83601 -1.42622 -640 1 16.7784 12.5316 9.7686 6.64513 16.9355 2.79564 -641 2 16.9553 11.9755 9.0112 -1.14761 -14.6768 -5.4217 -642 2 17.3143 13.3158 9.58219 -8.26404 -2.19889 6.01862 -643 1 6.14902 2.92407 2.76687 9.25618 8.55881 7.16487 -644 2 6.44579 3.84137 2.53376 -9.69316 -20.3131 -2.03165 -645 2 5.73381 2.47389 2.01355 1.00911 7.28801 -3.60537 -646 1 10.8507 3.14979 3.2526 -8.20022 -5.11042 -1.435 -647 2 10.2526 3.87795 3.44424 2.28516 4.24005 3.08111 -648 2 10.4324 2.67577 2.52169 3.50832 1.84172 1.62718 -ITEM: TIMESTEP -60 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.82699 6.8727 17.8888 7.11742 1.34647 0.262135 -2 2 7.99 7.13914 18.2565 -12.0864 4.19935 8.4109 -3 2 8.62901 6.07007 17.4227 -0.244169 -11.025 -10.1388 -4 1 18.7394 8.29949 6.7561 2.34576 -2.93089 -42.9257 -5 2 0.440553 7.9626 5.87052 -19.1153 18.5732 27.9896 -6 2 0.571955 7.78688 7.39134 9.59653 -12.4008 18.4821 -7 1 8.51178 18.783 6.87295 -6.05415 -5.58023 12.25 -8 2 9.39304 0.279078 6.53812 12.1519 1.3365 -4.9205 -9 2 7.9628 0.741428 6.37316 -1.87647 6.654 -3.74148 -10 1 6.53357 1.7197 11.6944 -32.7429 -8.61455 3.24653 -11 2 5.73579 2.18358 12.0739 27.4882 -10.0969 -10.5409 -12 2 6.18445 0.855878 11.3477 8.95005 26.2974 10.8481 -13 1 6.96535 5.62987 2.3961 35.6431 -32.0928 -15.0783 -14 2 6.38293 5.93218 3.05619 -24.6612 16.4463 30.6134 -15 2 6.84916 6.21974 1.66578 -5.97717 13.8881 -18.7681 -16 1 16.1974 10.2298 16.1222 0.837184 6.4903 1.28091 -17 2 17.0743 10.6189 16.0747 2.49014 -9.13099 -5.48379 -18 2 15.6463 11.0038 16.2733 -2.87215 -2.05097 1.79245 -19 1 10.6702 14.9469 2.31164 21.9083 12.0632 13.3283 -20 2 10.6818 14.2862 3.02723 -4.43621 6.7471 -1.73288 -21 2 11.263 15.6645 2.64965 -13.2726 -10.9824 -6.65814 -22 1 17.1701 8.22403 10.7142 -10.4028 1.03109 3.96163 -23 2 16.5672 8.79102 11.2349 7.05768 -1.94337 -2.70487 -24 2 17.9333 8.77716 10.499 4.44622 1.4788 -2.07857 -25 1 14.6797 15.9035 16.4693 -22.461 3.39408 -16.7947 -26 2 13.7484 16.2021 16.2951 24.3498 -9.2952 11.1 -27 2 14.6463 15.3225 17.2482 2.4047 10.3841 -3.14234 -28 1 12.1037 13.3669 0.54665 -3.27844 11.868 -6.89748 -29 2 11.8248 13.5865 18.2899 5.63772 -9.83511 -2.25753 -30 2 11.6388 14.0254 1.08354 0.310925 -7.08728 5.11983 -31 1 9.3344 5.48343 3.92748 33.8763 5.32583 -18.4372 -32 2 8.84687 5.22044 4.68611 -23.4915 -4.94858 24.7343 -33 2 8.7079 5.56619 3.20676 -14.265 -0.820383 -3.61874 -34 1 1.71101 4.06482 11.6122 14.6912 -29.1046 6.03323 -35 2 1.58258 4.96723 11.8918 -1.25551 20.6962 3.43651 -36 2 2.34968 3.65386 12.2459 -15.6865 7.58906 -11.285 -37 1 2.0576 6.82445 8.24528 12.7796 11.6573 13.2587 -38 2 2.61911 7.2356 8.94539 -14.081 -6.70064 -12.0447 -39 2 1.89349 5.9205 8.55263 1.83531 2.80349 -1.77694 -40 1 5.39864 4.45401 7.95786 1.68333 5.33174 7.59028 -41 2 5.55249 3.50745 7.87389 -3.64833 -7.88894 -5.24716 -42 2 4.83854 4.74959 7.2381 -8.525 -1.92619 -10.156 -43 1 3.30216 2.93412 17.4505 12.3495 -29.8256 -18.8762 -44 2 3.92727 3.3713 16.8479 -0.637689 -1.64749 6.41076 -45 2 2.89532 3.6118 17.959 -11.8167 26.1488 16.8317 -46 1 7.4312 5.4352 6.15055 3.3909 -0.433751 -53.1737 -47 2 7.92374 5.97877 6.73644 15.9967 14.3411 25.9486 -48 2 6.95714 4.77392 6.61797 -10.969 -14.5624 25.0012 -49 1 9.79304 6.98632 12.0044 -11.2776 3.50532 -30.3595 -50 2 10.3262 6.37648 11.4616 -6.26095 5.52929 9.55968 -51 2 9.10346 7.3395 11.3719 14.604 -9.64535 21.0978 -52 1 14.0819 3.68689 8.0984 5.37498 8.43639 24.1843 -53 2 13.9041 4.52495 7.65095 -1.63712 -2.30615 -0.914734 -54 2 14.2511 3.92795 9.04472 -1.39906 -3.736 -24.3353 -55 1 4.49163 17.2405 3.95076 10.4122 -13.5126 12.545 -56 2 5.41424 17.4498 3.85674 17.5711 4.37719 2.71306 -57 2 4.10795 17.4238 3.10711 -15.6864 12.0721 -17.6618 -58 1 16.4063 16.5742 10.3304 -30.4876 -1.09383 10.2792 -59 2 15.5552 16.587 10.8552 23.7267 -0.690427 -17.666 -60 2 16.1781 16.1401 9.48726 -2.06021 -0.342568 9.10707 -61 1 2.01216 4.81629 0.267482 -15.744 -7.33716 -25.0709 -62 2 2.32092 5.21812 1.07081 12.8803 9.20197 12.7852 -63 2 1.84588 5.54667 -0.35429 -3.07657 2.24499 6.46529 -64 1 11.4525 13.2643 16.3577 0.360612 25.402 13.2121 -65 2 11.0472 12.4174 16.5451 -7.76012 -9.6277 -2.94397 -66 2 11.9986 13.1376 15.5855 6.89063 -5.57893 -10.2697 -67 1 10.1527 10.9848 16.8633 -20.103 19.6526 2.73515 -68 2 10.5885 10.1542 16.8545 15.6291 -29.738 -2.50548 -69 2 9.22545 10.7635 16.7018 -0.592014 4.00252 0.856412 -70 1 11.7907 17.4531 13.47 6.77179 16.9038 -5.30963 -71 2 12.2429 16.8403 12.875 5.23267 3.61287 1.34276 -72 2 12.1771 18.3441 13.2664 -10.6628 -13.9509 7.62196 -73 1 6.44648 9.35189 12.2088 11.1766 16.4313 12.1054 -74 2 7.06476 9.1188 11.5034 -9.94127 -5.08631 1.40965 -75 2 6.99588 9.90362 12.7958 -7.62877 -4.94562 -4.27954 -76 1 16.2706 12.8594 2.68209 -1.75731 9.60563 4.91889 -77 2 17.1141 13.3556 2.57766 -16.4869 -7.21292 0.814827 -78 2 15.5397 13.5204 2.75856 19.4288 -8.85346 -2.79343 -79 1 0.706006 12.6575 5.91598 14.3848 1.31093 7.35726 -80 2 1.05127 12.3982 5.06653 10.4666 0.953953 -14.2919 -81 2 18.4268 12.7017 5.73438 -31.2224 -1.2993 2.30782 -82 1 5.26466 16.4058 18.4218 -16.1073 15.9927 3.08559 -83 2 5.67174 15.6665 17.9813 11.5666 -13.4602 -0.82172 -84 2 5.61268 16.4896 0.669718 7.09967 -3.66518 0.290508 -85 1 0.630514 7.71832 4.14439 -40.0144 -22.0429 16.8318 -86 2 18.6762 8.08291 3.48621 -5.56982 2.47832 -6.04635 -87 2 1.47362 7.93412 3.82987 48.6931 13.8203 -16.755 -88 1 3.15187 8.95984 6.48267 23.8542 8.38798 -14.0929 -89 2 3.71388 8.45844 7.06344 9.53544 -4.30832 6.22463 -90 2 2.31458 8.97258 6.8974 -32.9047 0.579586 11.7619 -91 1 7.26503 10.3427 16.2788 17.1997 0.0580756 -23.1821 -92 2 6.56569 10.7121 15.7432 -4.58149 2.66195 0.233626 -93 2 6.94547 10.3415 17.17 -9.40627 -4.59594 18.3856 -94 1 11.082 0.946861 5.00581 6.19269 9.74659 5.8053 -95 2 11.2852 1.82567 4.65658 -6.55006 -0.520752 -0.877191 -96 2 10.8571 0.430046 4.22808 -5.9868 -5.86677 -2.53499 -97 1 4.345 2.8292 13.2132 -1.27186 28.7368 -8.62995 -98 2 4.51529 3.21096 14.0791 1.17168 5.0352 0.572822 -99 2 4.2316 1.91147 13.3845 -6.13817 -32.6591 5.85186 -100 1 8.38376 10.2307 1.79685 4.09005 3.74222 -19.3624 -101 2 8.31491 10.9253 2.45197 -4.24337 3.92137 10.2746 -102 2 8.66929 9.45546 2.26885 2.27917 -12.8064 10.4703 -103 1 10.3305 1.70894 15.5022 6.01592 -1.55552 8.18831 -104 2 11.2875 1.57757 15.6324 -10.5356 -0.805047 -6.9053 -105 2 10.1546 1.87921 14.5629 5.4285 2.19916 1.25738 -106 1 2.65797 12.824 7.8537 2.67737 0.310449 -2.88199 -107 2 3.19441 13.4775 7.37699 -0.834696 -1.21778 5.43137 -108 2 1.94106 12.6113 7.24505 -1.36647 0.43678 -0.0339739 -109 1 3.78494 11.7026 5.05983 17.7759 13.7966 10.32 -110 2 3.63161 10.9725 5.64962 -3.29006 -9.81966 6.20688 -111 2 3.00915 11.823 4.52928 -13.3129 -0.91097 -10.8894 -112 1 6.77794 14.436 16.9596 -4.81268 9.99067 -5.99614 -113 2 7.54793 15.0018 17.1111 -0.926912 -4.93073 -4.17577 -114 2 6.38498 14.6674 16.0968 9.73202 -0.180074 3.30595 -115 1 14.2221 14.5157 3.27778 -13.9298 6.06594 9.9851 -116 2 13.8151 15.3779 3.06073 2.11094 -9.8452 8.88116 -117 2 13.8089 14.1856 4.11 4.80477 6.02161 -17.3229 -118 1 8.54544 18.1123 16.0497 -51.2002 16.193 -5.03192 -119 2 8.97127 17.2819 16.1484 30.3531 -21.0569 10.3371 -120 2 9.10378 0.243275 16.0887 21.8256 4.58901 -4.15396 -121 1 4.6724 1.65079 4.89395 -0.428695 -35.2982 26.3678 -122 2 3.9342 2.19791 5.10489 -21.2256 11.2309 2.3914 -123 2 5.17375 2.14476 4.28849 23.1392 22.1006 -30.0951 -124 1 14.9936 12.6291 16.4673 -19.77 11.4375 -24.1827 -125 2 14.4795 13.0601 17.1383 2.64859 2.32978 20.7439 -126 2 14.3496 12.6271 15.7247 18.4778 -8.83273 3.74622 -127 1 15.7172 18.4491 16.8771 -38.7365 1.31848 -37.9731 -128 2 16.4119 18.3751 17.4758 43.0193 1.36234 40.9307 -129 2 15.3332 17.5625 16.8778 1.44654 -2.1141 -5.88546 -130 1 1.31769 1.23679 16.6144 -6.54563 -5.62507 -9.64947 -131 2 2.12749 1.70533 16.7963 11.1847 9.69542 4.67012 -132 2 0.698368 1.60678 17.2434 -6.22801 1.29783 7.94738 -133 1 18.1828 4.42633 15.9571 -10.2445 4.38521 4.02875 -134 2 18.0727 3.95797 15.1342 -1.32851 -5.12675 -7.69371 -135 2 0.442412 4.30859 16.2307 9.57607 0.794437 2.0974 -136 1 12.2114 16.9885 16.1505 19.3184 14.9656 -43.0527 -137 2 11.4192 16.582 16.4369 -30.1172 -13.2398 21.5491 -138 2 12.0643 17.0779 15.1772 3.25614 1.68146 17.8786 -139 1 16.0795 2.58494 18.1555 11.3664 -10.2705 19.274 -140 2 15.8693 3.49863 18.3 -12.3112 17.2654 5.58069 -141 2 15.8977 2.41247 17.2454 -5.4363 -1.34473 -24.067 -142 1 6.67972 13.8354 10.1508 -8.25744 -4.72138 -13.3408 -143 2 6.54568 13.5231 11.0561 -0.87434 -6.75398 -1.82198 -144 2 6.44555 13.1152 9.51962 7.50297 7.52708 13.7797 -145 1 10.1393 18.4632 2.72581 -2.6903 -13.3312 7.25948 -146 2 10.3702 0.440572 2.04373 3.08075 7.1003 -10.4416 -147 2 9.34905 18.0295 2.38643 -2.95732 2.6687 3.95308 -148 1 3.05039 17.7207 6.12428 0.448774 -3.44066 -6.39261 -149 2 2.22716 17.4884 5.64326 9.1847 7.623 2.40325 -150 2 3.74061 17.8548 5.44564 -15.5509 -1.85687 4.81473 -151 1 12.5974 16.8374 7.98109 22.5462 3.91689 -18.138 -152 2 11.9813 16.1063 7.98041 -18.255 -3.99171 0.854341 -153 2 12.4106 17.4726 8.66951 -8.78709 2.06599 13.7307 -154 1 14.8906 15.2874 8.20197 12.2291 6.1037 -1.40009 -155 2 14.0169 15.6824 8.32954 6.14586 6.92547 -6.68196 -156 2 15.3058 15.6925 7.40177 -13.6896 -13.6819 15.1947 -157 1 17.774 18.2462 0.317021 16.5526 -0.292921 -8.65749 -158 2 18.517 17.6459 0.018512 -14.2865 26.6269 11.4024 -159 2 18.1212 0.514643 0.485201 -2.53379 -23.9559 -4.59837 -160 1 0.824062 10.4854 1.38532 29.0751 41.1299 -24.8426 -161 2 0.152225 9.85957 1.54468 -35.7643 -25.6114 8.77961 -162 2 0.463481 11.18 0.764874 10.1431 -20.9883 20.7352 -163 1 1.76832 12.2434 3.3342 -0.376699 -6.62105 -8.54196 -164 2 1.60728 11.5206 2.66813 -0.613387 21.7926 10.4725 -165 2 1.98383 13.0773 2.86566 -4.64348 -14.8628 -2.7215 -166 1 0.631416 17.2455 4.93339 -1.94983 -6.83399 6.66588 -167 2 18.8682 18.1422 4.98859 -2.83763 -23.6492 7.38562 -168 2 0.299607 16.5671 5.5918 8.11627 31.0276 -16.6779 -169 1 1.13057 0.905706 9.36586 -12.3827 -0.18715 22.5068 -170 2 1.31261 0.747855 10.3312 -4.25497 -2.51626 -23.3877 -171 2 0.268645 0.477115 9.21068 10.8181 5.54227 0.850191 -172 1 16.7346 2.37332 13.3038 3.72479 1.84576 21.5886 -173 2 16.9761 2.56684 12.4028 0.0757035 3.67621 -15.1405 -174 2 16.5678 1.42686 13.3713 -2.69734 -3.58003 -5.961 -175 1 2.71222 15.8556 12.0453 -23.2953 18.5694 10.7935 -176 2 3.02055 15.4773 12.8617 6.20357 -6.16654 7.20198 -177 2 3.26455 15.5565 11.3309 7.18341 -3.43964 -7.05157 -178 1 16.426 15.6488 6.1101 -14.7609 -25.4644 9.17481 -179 2 17.2826 15.6571 6.51544 16.1879 -4.44611 5.83009 -180 2 16.438 16.358 5.49538 -5.11113 23.225 -23.4349 -181 1 5.76882 5.13637 11.8122 -12.0704 17.5482 5.11471 -182 2 5.44081 5.9885 12.2003 4.95719 -19.5528 -5.70673 -183 2 5.01212 4.52871 11.8104 6.55972 2.89024 2.61392 -184 1 15.1343 4.86498 0.81249 17.6468 10.3526 -37.7608 -185 2 14.8624 4.60472 1.67155 -6.094 -8.43385 31.413 -186 2 14.42 5.38891 0.454388 -5.76674 3.16257 -0.979918 -187 1 16.354 16.4047 2.01729 -13.9507 10.6217 3.88258 -188 2 15.8491 16.8174 2.76015 19.926 -7.04016 -11.695 -189 2 16.7635 17.1307 1.5183 -3.64457 0.258913 2.52225 -190 1 0.229093 4.84171 3.85636 -16.5361 -39.1535 -9.01102 -191 2 0.280674 5.76384 3.97165 5.27146 43.6678 4.59383 -192 2 0.903367 4.46589 4.41298 10.8 -4.72049 2.86342 -193 1 2.98031 15.0696 15.1724 7.38994 17.2595 -26.1187 -194 2 2.78389 14.6733 16.0132 -4.59533 -4.91572 22.4357 -195 2 2.69496 16.0061 15.2442 -6.09825 -12.2809 0.399162 -196 1 1.14224 14.6486 9.53301 9.69931 -12.3423 3.57818 -197 2 2.08157 14.8372 9.66442 -5.69448 4.03807 -1.75917 -198 2 1.10168 13.6946 9.72739 -6.61933 10.5759 -2.74939 -199 1 13.5148 16.5367 11.5259 11.0739 -5.14125 9.92262 -200 2 13.0998 17.2443 11.0437 -3.0151 15.655 -8.61356 -201 2 13.0781 15.7617 11.1648 3.09342 -5.90037 -0.559148 -202 1 4.6468 1.4492 0.760442 21.9419 17.6404 -6.63386 -203 2 4.03376 2.00221 0.272437 -3.30289 2.18566 -6.21296 -204 2 4.11186 0.849122 1.26962 -7.6403 -10.762 3.4591 -205 1 1.46385 18.5705 11.8684 11.5971 1.37494 19.5738 -206 2 1.40443 0.572196 12.6059 -0.800227 -11.3118 -6.50307 -207 2 2.03902 17.8403 12.1929 -11.6325 11.1906 -9.16825 -208 1 11.4878 10.1514 4.00495 -23.562 -17.5625 40.225 -209 2 11.4445 10.4449 3.12053 -0.0273244 15.9845 -32.1431 -210 2 12.4087 10.0544 4.20335 22.0666 -0.101113 3.57488 -211 1 8.17978 12.1587 3.71493 28.653 -3.15285 -17.361 -212 2 9.01377 12.5671 3.97927 5.41625 0.887106 1.05136 -213 2 7.604 12.3558 4.43149 -23.5411 2.07968 29.6007 -214 1 14.5452 4.04195 3.30356 -17.0528 -5.31405 -8.64237 -215 2 15.1661 4.06926 4.02931 6.41379 4.8272 12.7333 -216 2 13.7233 4.44982 3.62226 2.87412 -0.159853 0.628569 -217 1 5.66111 1.64664 7.53337 47.3068 24.6854 -47.7691 -218 2 4.99385 1.2169 7.99076 -47.8059 -33.9417 34.4755 -219 2 5.55481 1.33937 6.59792 -2.0798 14.2024 17.8553 -220 1 17.8737 1.09537 4.84004 -13.6202 -14.1831 4.02096 -221 2 18.464 1.49436 4.20233 9.91759 7.15437 -5.32228 -222 2 17.8561 1.60546 5.65338 7.58498 6.35358 2.28946 -223 1 6.84561 9.39092 4.51119 3.77645 -4.79561 13.9854 -224 2 6.80242 9.62767 5.4641 3.30223 -6.77647 -16.668 -225 2 7.74702 9.0401 4.34673 -10.1352 5.61637 3.28246 -226 1 2.64818 14.8733 2.0031 -12.6643 -4.21043 8.13073 -227 2 3.39044 14.7832 2.61388 1.60205 1.10943 -1.58393 -228 2 2.93662 15.3311 1.21566 8.61024 -0.712779 -4.79925 -229 1 17.3356 12.9304 13.2091 0.397713 16.5012 -11.0143 -230 2 16.4513 13.2838 13.3976 5.15185 -2.46087 0.53778 -231 2 17.8465 13.7314 12.9621 -7.21788 -13.1567 2.02539 -232 1 14.9178 10.5628 1.45295 0.32879 33.5889 18.189 -233 2 15.3786 11.3985 1.79277 -12.1624 -32.8958 -12.3175 -234 2 13.9692 10.6935 1.62732 12.9477 -1.40805 -3.43718 -235 1 5.70482 6.69167 4.56094 -12.9541 28.0444 -8.31435 -236 2 5.76223 7.67071 4.46331 5.24004 -15.8993 1.97075 -237 2 6.3673 6.43877 5.21208 3.70858 -3.97365 0.601716 -238 1 7.97185 8.33683 10.3069 8.6941 -15.2025 -3.68424 -239 2 8.60404 8.92215 9.84221 -9.13329 -6.11086 -5.89913 -240 2 7.51742 7.70171 9.70626 6.59476 18.8917 -0.227694 -241 1 13.4177 18.464 5.71198 21.9916 6.6123 -14.6219 -242 2 12.6947 0.421284 5.51228 -9.11836 -2.12279 2.23123 -243 2 13.1839 18.0173 6.51737 -9.90438 -14.4062 13.6987 -244 1 0.0221035 2.62655 0.261444 12.6472 -47.1951 11.8456 -245 2 17.7527 2.75577 18.6598 -10.3686 10.7513 -7.61459 -246 2 0.546882 3.40438 0.188377 7.87852 33.0005 -3.15527 -247 1 12.8067 10.9927 9.75832 44.9647 -24.4125 8.46131 -248 2 11.8751 10.9314 9.65932 -31.4773 -7.30673 -3.09024 -249 2 13.1121 10.0761 10.034 -17.0663 24.2241 -8.13324 -250 1 0.673563 12.1459 11.0385 -14.9158 10.2345 17.3916 -251 2 18.3756 12.1565 11.2954 6.68564 0.0119082 -11.299 -252 2 1.10384 12.3853 11.8646 9.18612 4.40652 0.693569 -253 1 5.14721 7.33361 13.3929 15.7357 3.63047 1.84442 -254 2 5.59488 8.13358 13.0475 0.482915 -12.4288 -2.35902 -255 2 5.71887 7.03407 14.1269 -8.93121 6.52874 -3.37327 -256 1 1.18567 6.84505 11.8697 14.6786 34.5125 12.17 -257 2 0.393465 7.21987 11.4553 4.74321 -4.21777 2.31791 -258 2 1.70022 7.64215 12.2222 -16.972 -31.3024 -13.5319 -259 1 15.4816 9.69158 12.3277 9.90347 -39.8653 -1.57959 -260 2 15.3406 10.5924 12.1653 -13.2531 41.4735 -11.5871 -261 2 15.406 9.62533 13.2698 1.46249 -6.23285 16.1579 -262 1 16.5413 12.6347 5.5059 7.75274 -6.4804 14.118 -263 2 16.3104 13.5445 5.70094 -2.97213 12.2972 0.10227 -264 2 16.3923 12.5258 4.56955 -2.98329 -0.0504447 -18.3871 -265 1 6.30461 9.82716 0.0624729 6.72618 23.4574 16.6882 -266 2 5.51437 10.3287 0.304315 -0.069722 -0.440899 2.51054 -267 2 6.96842 10.0501 0.765687 -11.6212 -9.0506 -14.676 -268 1 12.2588 6.10042 4.03099 15.0483 24.7381 -3.94445 -269 2 12.3021 6.98896 3.58767 -5.34003 -28.327 1.95056 -270 2 11.3325 5.86569 4.06669 -11.2394 -4.89225 -2.88949 -271 1 0.336489 12.822 0.136131 -4.0328 -4.68121 -1.73262 -272 2 -0.0692718 13.3776 0.815875 4.64589 5.49593 0.971726 -273 2 18.45 12.9344 17.9884 -7.92492 5.13291 -5.47118 -274 1 3.58866 18.6351 8.62238 -6.65617 9.61834 5.79691 -275 2 3.41901 18.3768 7.70859 0.297411 -7.32139 -0.213682 -276 2 2.71275 0.31261 8.92207 15.7588 -5.16119 -5.17535 -277 1 7.50496 17.418 4.49772 -12.5742 -28.6928 8.65377 -278 2 7.55283 18.3491 4.58726 6.16277 33.1384 2.27358 -279 2 7.74423 17.2559 3.59134 -1.33953 -2.22923 -11.883 -280 1 9.26392 17.1331 12.2129 -23.7136 4.99112 -6.35848 -281 2 9.34774 16.2465 11.866 0.0093118 -9.2577 -7.50778 -282 2 9.98892 17.2487 12.8038 23.7327 3.38143 15.862 -283 1 13.3751 13.0337 7.97577 10.7478 10.6887 -13.5108 -284 2 13.3787 12.2298 8.50206 6.89696 -2.46192 7.10708 -285 2 14.2592 13.4885 8.01338 -22.4634 -9.00878 7.77512 -286 1 14.8592 2.99547 15.3735 -5.27851 1.66435 23.9116 -287 2 14.1885 2.32373 15.2402 -1.63897 -5.65445 -5.41614 -288 2 15.4149 3.00295 14.6023 9.16888 -1.78425 -15.607 -289 1 9.86925 15.6154 16.9672 4.33331 -1.89849 4.26663 -290 2 10.4152 14.8537 16.7052 -6.80597 -3.90746 -0.277805 -291 2 9.57771 15.4416 17.8827 0.419377 0.378738 -9.64067 -292 1 11.2678 8.44973 16.5939 -8.08747 -14.0791 2.0813 -293 2 10.6693 7.85604 16.0792 7.94549 12.4538 10.9378 -294 2 11.4172 8.01973 17.4598 -1.80582 0.647834 -14.6449 -295 1 3.91551 18.1683 16.8005 9.39931 12.2215 14.3903 -296 2 4.49606 17.6509 17.3756 -3.52447 -10.1131 -6.81095 -297 2 3.95318 0.38369 17.2365 -5.94998 0.470214 -7.14863 -298 1 2.19966 4.20574 8.91394 -16.952 6.25086 -28.7566 -299 2 3.11163 4.1112 8.67966 19.1354 -3.54458 -0.459765 -300 2 2.10589 3.95692 9.81579 -0.00585893 -3.49833 31.5267 -301 1 9.86514 10.3731 9.72031 15.6542 -41.5135 2.74879 -302 2 9.61489 11.2182 9.40808 -14.4527 35.546 -8.7168 -303 2 10.0569 10.3888 10.6595 -0.965326 6.48855 10.4451 -304 1 9.65603 0.92083 10.8651 15.4128 -5.93628 -1.69563 -305 2 9.35399 0.0448876 11.1808 -6.92756 10.8331 -8.061 -306 2 9.08478 1.27687 10.159 0.925367 -10.2687 5.27886 -307 1 9.17601 15.08 10.2001 28.4704 15.1584 7.58672 -308 2 8.86011 15.9493 9.94215 -4.94078 5.46469 -8.90142 -309 2 8.40516 14.5378 10.1682 -22.1716 -15.7686 -1.61012 -310 1 0.908908 9.65777 10.2661 1.02783 -39.6886 -13.0526 -311 2 0.968686 10.5462 10.5861 7.37828 17.5094 1.10535 -312 2 1.79128 9.34954 9.98968 -11.6106 9.29057 7.26807 -313 1 16.9796 4.82858 8.10785 29.2892 -10.1291 -25.9715 -314 2 16.4029 5.49318 8.42182 -23.755 22.5857 11.698 -315 2 16.8784 4.07707 8.6652 -3.89501 -13.8815 13.5617 -316 1 14.7893 14.6979 0.173135 5.39554 -7.96858 -12.7144 -317 2 15.0505 15.3823 0.785417 9.36392 5.93735 12.263 -318 2 13.9789 14.3219 0.494521 -15.109 -8.03615 11.244 -319 1 3.74323 11.0124 9.54886 4.38849 -4.14114 10.1409 -320 2 3.63158 11.395 10.4392 1.27308 -1.67175 -3.21468 -321 2 3.24423 11.5652 8.93525 -2.74645 9.31742 -2.2917 -322 1 11.2573 10.7534 1.46897 -2.74628 -20.4518 -2.00657 -323 2 11.6064 11.5358 1.05536 3.45865 20.4344 -8.16659 -324 2 10.3358 10.6724 1.18755 -1.77969 3.26872 -0.743535 -325 1 13.1779 7.19199 12.7182 14.2184 -9.05364 3.75753 -326 2 14.115 6.87295 12.7816 -17.4164 8.42328 -3.38551 -327 2 12.6212 6.40428 12.8017 3.66516 -2.90974 1.8722 -328 1 9.6094 1.86333 0.961036 -1.66559 10.1622 -20.0065 -329 2 8.74982 1.7634 0.476399 21.9169 -1.84649 8.18396 -330 2 10.2659 2.29351 0.366445 -15.6421 -6.48907 5.12748 -331 1 10.6591 13.4925 4.58018 -19.1141 -0.630091 -16.1529 -332 2 11.5305 13.1262 4.70232 12.5696 -8.82773 5.21944 -333 2 10.586 14.1761 5.24203 -0.728557 4.94256 14.6221 -334 1 14.495 1.73909 10.9749 -8.14936 -7.82556 -5.33359 -335 2 15.2253 1.30703 10.5146 2.44721 2.03735 2.44955 -336 2 14.6402 2.68373 10.8341 0.821335 1.15578 7.11863 -337 1 14.5247 12.1307 11.6327 6.29346 4.76638 51.459 -338 2 15.3146 12.4097 11.1999 18.4985 9.73575 -23.8815 -339 2 13.8662 11.9319 10.9987 -20.1843 -8.01501 -29.1382 -340 1 8.1934 5.08514 9.85848 20.6286 -7.50881 -18.2265 -341 2 7.39102 5.12991 10.3666 -14.5844 -3.05188 8.40055 -342 2 8.26178 4.1705 9.49849 -5.86813 14.6103 10.9415 -343 1 1.56363 16.9354 18.4208 -1.17306 -23.9048 5.52961 -344 2 2.13897 17.2639 17.7268 3.56106 5.06395 -9.30964 -345 2 1.54669 15.9596 18.2963 3.84009 16.9778 0.440392 -346 1 1.49268 17.3196 15.3241 -27.5122 8.95969 8.58328 -347 2 1.46041 18.2525 15.6844 -4.86102 -31.3543 -7.55486 -348 2 0.570896 16.9106 15.346 29.8648 20.9529 0.539048 -349 1 3.59911 5.78915 6.06648 9.03859 -15.9659 -5.84137 -350 2 3.1214 6.40715 6.60976 -11.746 7.94276 10.4286 -351 2 4.15987 6.31414 5.47841 1.03618 -2.86439 -0.897012 -352 1 12.5136 9.4824 14.2234 -14.5482 39.9006 11.9441 -353 2 12.9252 8.74241 13.842 20.5687 -36.5434 -22.703 -354 2 12.2915 9.17254 15.1019 -4.72781 -1.84288 9.93497 -355 1 4.05984 15.2792 6.9471 -25.1121 -18.1042 13.4141 -356 2 3.54373 16.0393 6.6659 -0.213909 7.77754 -0.115815 -357 2 4.94872 15.4739 6.70425 29.3053 8.29501 -4.075 -358 1 0.70733 8.67925 15.049 -6.53077 -6.52645 2.33041 -359 2 0.403057 9.59211 15.0995 2.0449 7.24241 -1.44461 -360 2 1.39578 8.67212 14.3782 6.73055 2.7204 -4.7895 -361 1 12.9505 8.27543 10.2426 2.52256 -9.36522 19.2887 -362 2 13.7222 7.81068 9.89429 1.56507 0.683648 -5.24915 -363 2 12.8789 7.88642 11.1491 -0.00217653 14.5673 -16.6218 -364 1 15.3477 7.80216 3.55401 -12.532 5.83489 -12.7989 -365 2 14.4906 7.48222 3.33103 -16.8871 -2.65253 -29.4538 -366 2 15.2947 7.61797 4.46883 25.5814 -3.41235 36.6493 -367 1 17.266 6.70187 0.000674068 12.1195 -8.95496 8.26487 -368 2 16.7457 6.00049 0.395257 -2.87342 -9.15243 0.336143 -369 2 16.622 7.35704 18.4101 -17.4752 15.3525 -8.08793 -370 1 8.88335 6.95399 7.81342 26.8473 24.5973 -5.8387 -371 2 9.80542 7.33522 7.87938 -25.1058 -10.3372 -2.45861 -372 2 8.7714 6.40725 8.58367 -2.11125 -14.3958 16.4377 -373 1 12.3879 0.548843 1.24082 4.42765 -0.472301 -1.45686 -374 2 13.3265 0.730859 1.40339 -2.38609 2.78881 -0.689397 -375 2 12.2563 0.636326 0.292606 2.56041 -5.4085 -0.678049 -376 1 5.63248 15.1125 14.5468 -9.48886 -16.8407 5.02155 -377 2 4.69503 15.2624 14.7723 5.83199 -5.28539 -1.87026 -378 2 5.99589 15.9615 14.314 8.44734 16.7096 -6.42729 -379 1 3.85575 6.39433 1.75493 1.50274 -8.79363 8.51258 -380 2 3.48975 7.20754 1.41538 -8.87879 17.021 -2.96274 -381 2 4.03803 6.55873 2.69128 -1.36395 1.28851 -4.88856 -382 1 3.93631 11.5299 12.3893 -8.10483 -0.317118 -5.66906 -383 2 4.80663 11.9435 12.4577 -3.51298 -1.2689 0.972005 -384 2 3.32279 12.1457 12.8171 1.30391 -5.08042 -1.13556 -385 1 5.30379 3.85961 15.861 3.26535 -66.7729 -21.4105 -386 2 5.99128 3.21668 15.5051 -18.0074 17.9789 14.3955 -387 2 5.71814 4.68422 15.8683 22.7973 48.3912 1.26107 -388 1 14.279 10.1761 4.52146 -28.2637 29.6843 37.5781 -389 2 14.4726 9.82647 5.40905 -2.50301 -0.0307068 -4.88302 -390 2 14.7482 9.65242 3.92054 26.3189 -27.9191 -30.9088 -391 1 7.73542 17.3919 9.15036 20.9187 -26.1564 3.32362 -392 2 6.89787 17.6412 9.51878 -14.391 11.6651 3.78997 -393 2 7.98556 17.9488 8.40931 -4.18052 11.5531 -5.69175 -394 1 4.50439 14.5239 3.99264 11.0977 -23.3764 -48.4991 -395 2 4.56306 15.4325 4.20277 -1.38797 35.5351 15.6514 -396 2 4.31322 14.0314 4.76491 -6.35847 -16.1784 30.998 -397 1 14.1606 7.45193 15.811 -24.1382 -9.56247 -10.586 -398 2 15.0553 7.36431 15.524 24.9604 -3.00047 -8.7167 -399 2 14.2305 7.91189 16.6334 1.28104 8.01927 19.5585 -400 1 2.99693 18.3516 1.90386 -17.8633 -43.3253 -26.4279 -401 2 2.47403 17.7132 1.31624 19.6124 26.5697 18.0429 -402 2 2.33007 0.205152 2.36966 -11.145 11.7012 10.1025 -403 1 8.00896 1.59538 4.54643 -14.6935 -3.1209 6.18761 -404 2 7.42733 1.99671 3.8763 8.34922 -0.442348 -1.34208 -405 2 8.90764 1.54031 4.21745 2.64121 3.0498 -7.75206 -406 1 2.41984 14.15 17.6911 38.7391 17.8224 -8.42313 -407 2 1.65201 13.6768 17.9262 -26.9962 -21.4224 14.4939 -408 2 3.15619 13.6354 18.0755 -0.305296 5.75785 -2.4818 -409 1 0.881322 1.80893 13.8899 -12.9164 4.63859 7.1799 -410 2 0.998981 1.67187 14.8549 -5.47541 -0.367675 -15.7697 -411 2 18.568 1.96442 13.7158 18.7475 -1.65173 8.16576 -412 1 4.35626 0.108756 13.8915 -10.9503 4.16473 7.68997 -413 2 5.20313 18.36 13.6952 15.0207 -4.30703 2.98167 -414 2 4.18562 18.5651 14.8318 -0.53115 -1.77986 -5.89667 -415 1 7.21985 0.783193 18.3638 -3.94277 -6.88163 -25.1551 -416 2 7.12969 0.383485 17.4575 9.77138 9.98351 24.3944 -417 2 6.41237 1.28912 18.5059 -6.03182 -4.67978 5.08395 -418 1 15.9996 18.4041 13.9383 18.1315 -1.4443 -10.5581 -419 2 15.071 18.4425 13.7445 -14.3326 2.53282 3.85714 -420 2 16.1651 18.6473 14.8506 -8.9044 -3.87569 12.2679 -421 1 10.1939 4.54115 16.2821 35.3159 -4.68875 2.87762 -422 2 11.1919 4.40884 16.3129 -34.2522 14.5881 -3.55905 -423 2 9.86192 3.67371 16.0442 -3.43039 -7.24249 -0.81883 -424 1 15.9323 17.7355 4.44233 22.6638 -20.6434 -12.8847 -425 2 16.5412 -0.18272 4.5755 6.4476 10.7336 -1.45992 -426 2 15.0915 18.0468 4.70328 -34.4096 13.9436 14.4512 -427 1 6.99117 17.4686 13.8836 -42.0334 -7.7574 -17.1448 -428 2 7.47631 17.7428 14.6303 20.6357 14.1189 34.523 -429 2 7.65356 17.3815 13.215 15.8945 -3.28854 -19.4769 -430 1 13.2291 6.49408 6.5607 17.0277 2.09005 0.593761 -431 2 14.1816 6.76782 6.52286 -25.3304 -6.60509 -4.73803 -432 2 12.9166 6.35235 5.64754 5.89534 0.461784 7.57918 -433 1 7.85324 2.32148 9.35275 5.46391 6.9162 26.9577 -434 2 7.3686 2.17076 10.1976 2.69269 5.61176 -14.2633 -435 2 7.26481 2.08775 8.6472 -14.0957 -9.57593 -14.6111 -436 1 15.2023 14.7793 13.7187 7.74208 -16.2001 -4.59991 -437 2 14.8319 14.9596 14.5759 -4.08925 6.59301 14.3355 -438 2 15.0747 15.5488 13.1771 -7.6118 10.0658 -7.58078 -439 1 9.41047 8.32341 3.83123 -6.47708 13.1987 -5.34522 -440 2 10.2452 8.80483 3.85219 3.73168 3.01968 4.76716 -441 2 9.63137 7.40393 3.95808 -1.29777 -11.5098 0.542939 -442 1 17.7649 13.5922 16.3898 -11.4367 -25.6902 16.7919 -443 2 16.7908 13.5407 16.3666 6.32242 -2.67761 -0.626712 -444 2 17.9873 14.3645 15.8914 0.275374 22.0623 -11.5119 -445 1 4.92213 10.5724 2.8597 -4.83644 2.51404 -15.3254 -446 2 5.59736 10.2151 3.4378 8.5726 -2.027 3.49443 -447 2 4.66951 11.4171 3.23999 1.02108 -1.77966 3.70944 -448 1 3.74742 8.38157 10.0278 -2.2319 9.94706 -11.0912 -449 2 3.89489 9.30484 9.7273 -4.74563 -10.9217 8.16333 -450 2 3.84233 8.40088 10.9831 -0.997449 0.744123 6.62097 -451 1 15.9666 6.96875 6.01253 -14.8276 15.8227 3.08109 -452 2 16.7817 7.37259 6.30064 12.9112 7.94175 5.43996 -453 2 16.2196 6.12219 5.66656 5.41287 -21.5059 -0.527712 -454 1 15.1391 7.15478 9.02923 3.95319 -30.3017 38.192 -455 2 15.9165 7.52141 9.44882 9.73374 3.98045 10.059 -456 2 15.0698 7.60427 8.22918 -5.81948 28.1077 -46.3627 -457 1 6.22822 12.9188 12.7298 1.31868 -8.19268 -13.1839 -458 2 6.88351 12.2656 13.01 8.10485 3.82836 6.8834 -459 2 6.11855 13.5785 13.4162 1.19396 9.04898 12.3458 -460 1 12.1253 4.52441 13.1066 -23.5121 -14.293 -11.093 -461 2 12.4631 4.60406 14.0095 -9.44452 -2.69015 3.06865 -462 2 11.2831 3.97256 13.0795 31.8956 18.265 6.80246 -463 1 11.4055 8.12657 7.94639 -16.7563 2.96014 -17.3287 -464 2 11.9383 7.50834 7.43372 10.7385 -1.00284 -0.366803 -465 2 11.8652 8.24712 8.77366 5.83315 -1.26494 14.2429 -466 1 17.1037 10.8819 7.56719 -22.1575 4.54299 3.0458 -467 2 17.7705 10.2842 7.28531 25.0286 -24.4015 -2.83309 -468 2 16.8908 11.3655 6.76798 -3.05919 12.9941 -4.73253 -469 1 5.25302 18.1256 10.9232 26.818 -0.191878 -4.18594 -470 2 4.8269 17.8089 11.6994 -14.1597 -10.1429 18.6642 -471 2 4.64144 17.9747 10.2197 -19.8227 3.49229 -23.3423 -472 1 7.59833 17.4619 1.74995 8.37542 2.1771 -36.4257 -473 2 8.02215 16.748 1.21035 -16.0406 12.4022 13.5887 -474 2 7.374 18.1677 1.08602 7.01745 -13.9463 17.8331 -475 1 1.92633 12.907 13.6044 0.0880561 -5.46821 -16.7511 -476 2 1.47807 12.3822 14.2652 -4.39349 -7.86198 7.054 -477 2 2.32754 13.632 14.072 3.07665 17.0427 10.8635 -478 1 9.50987 6.80039 14.836 2.18935 -20.8269 12.8739 -479 2 9.79082 5.96037 15.3114 -4.54962 20.4196 -21.9392 -480 2 9.66995 6.7436 13.8735 6.47407 0.337666 8.03802 -481 1 15.2827 4.32341 10.7768 10.307 9.68599 -4.89646 -482 2 16.2397 4.0919 10.6916 -21.0983 9.39835 9.69703 -483 2 15.2266 5.10894 11.3663 5.46907 -15.4805 -5.79884 -484 1 11.3016 6.20596 0.140794 12.6043 6.09542 0.747046 -485 2 11.4786 5.29078 18.6344 12.8703 -22.3778 -2.75052 -486 2 10.381 6.25156 -0.0726873 -21.1699 14.4442 -0.985902 -487 1 -0.0715916 11.4097 14.9721 22.1692 -7.15633 35.3796 -488 2 18.1992 11.7732 14.1947 -21.0416 8.6568 -29.4322 -489 2 -0.201181 12.1402 15.5966 -0.594523 -4.50066 0.166015 -490 1 7.04588 9.27411 7.30476 9.145 16.929 -11.701 -491 2 6.64583 8.45304 7.57308 -6.76023 -15.305 10.0219 -492 2 7.98749 9.10222 7.20319 2.10913 -2.81405 2.65036 -493 1 18.3255 15.3308 12.2943 -10.9271 3.22482 1.76971 -494 2 0.551901 15.6023 12.004 16.2571 0.370549 -2.10144 -495 2 17.7334 15.6802 11.6169 -1.97195 2.58378 -3.71708 -496 1 16.5011 4.39937 5.27673 4.48444 11.2976 -56.5136 -497 2 16.7777 3.84422 5.96849 7.0389 -19.8316 37.8082 -498 2 17.2036 4.29545 4.59204 -6.79319 11.0559 14.2779 -499 1 17.7009 3.16012 10.7623 -11.0785 -13.2259 -8.21854 -500 2 -0.0365931 3.41438 10.9472 14.4195 -1.11458 2.04579 -501 2 17.6933 2.32175 10.2562 4.60522 6.17753 6.57508 -502 1 12.2846 -0.0106908 10.1146 7.09195 -37.1879 -10.2172 -503 2 11.3926 0.256016 10.2673 -25.9358 14.4274 7.98014 -504 2 12.8288 0.732071 10.298 19.2326 28.445 5.65892 -505 1 10.3866 9.75519 12.5017 -6.95633 -10.4248 -20.8372 -506 2 11.1983 9.82383 13.0055 7.4239 -2.70171 9.41801 -507 2 10.3064 8.80301 12.2683 1.05955 14.1529 10.144 -508 1 0.648708 2.774 7.07027 -1.36725 -4.55963 12.8723 -509 2 0.490272 3.61188 7.51443 -2.95105 4.17746 -2.75047 -510 2 1.10621 2.25999 7.75495 -4.79333 -3.92365 -3.87978 -511 1 0.307244 15.292 6.87913 -0.83379 49.2439 44.5727 -512 2 0.652444 15.3347 7.80405 -9.58611 -2.1659 -14.8737 -513 2 0.567348 14.4512 6.61032 15.5663 -52.8882 -22.8213 -514 1 17.056 6.99125 15.1184 -7.99596 0.858836 -4.56633 -515 2 17.7814 7.62276 14.9808 0.742784 -5.19204 3.90514 -516 2 17.4035 6.24942 15.6288 5.94943 -0.679765 0.413052 -517 1 9.13726 12.4999 8.01885 37.0353 0.885775 16.8739 -518 2 9.52568 11.8572 7.39973 -10.6447 2.68521 -0.695331 -519 2 8.21726 12.5875 7.87097 -30.0746 -3.81245 -10.8301 -520 1 1.21553 1.74407 2.88052 -2.59699 -2.39415 1.38589 -521 2 0.835324 2.14494 2.08419 1.70776 2.79001 2.24225 -522 2 1.71989 2.41102 3.3678 0.071784 1.92406 -2.09937 -523 1 4.07628 15.1457 9.88397 17.4433 -7.82557 -1.54586 -524 2 4.111 15.2412 8.92029 0.253189 0.655179 -3.36934 -525 2 4.94389 14.7737 10.148 -8.68797 4.30724 -10.2942 -526 1 7.35101 2.21809 14.6867 -7.35168 5.20952 -5.71558 -527 2 7.12719 1.57839 13.9999 0.606569 0.313122 2.88765 -528 2 7.62455 3.00796 14.1978 2.82745 -2.40467 5.3071 -529 1 18.457 14.6023 2.16488 -22.5257 23.4253 1.52633 -530 2 0.650438 15.0238 2.37846 9.31401 -4.06208 0.652559 -531 2 17.8015 15.3468 2.21006 9.59865 -20.266 -2.54542 -532 1 9.9778 2.69966 12.9163 0.655502 16.6224 11.2027 -533 2 9.96654 2.13525 12.1425 -5.01566 -7.38072 -9.38582 -534 2 9.27217 3.36428 12.8011 2.98946 -10.098 -0.342741 -535 1 2.95791 8.92102 13.0894 10.3197 8.62466 2.37945 -536 2 3.25022 9.8484 12.9226 -2.55555 -16.3803 0.657875 -537 2 3.7553 8.44758 13.4136 -17.8894 4.38499 -5.11642 -538 1 3.26012 8.5452 3.75851 7.68136 4.64814 -61.3797 -539 2 3.65213 9.34274 3.2957 -8.84339 -23.8918 18.3111 -540 2 3.19772 8.72964 4.66662 3.169 13.2307 40.2657 -541 1 5.70723 7.22602 8.61089 15.0471 5.15238 -9.7988 -542 2 5.61347 6.27934 8.4361 -3.3163 0.301479 7.52532 -543 2 4.97449 7.5436 9.15453 0.52499 -8.4302 1.10573 -544 1 14.8706 1.4621 1.8863 1.70998 27.5213 20.9307 -545 2 14.7201 2.23316 2.46749 -8.28585 -15.753 -0.675778 -546 2 15.5631 1.82311 1.33978 3.90729 -10.8233 -20.0391 -547 1 8.4891 15.095 0.746196 -1.67248 3.44686 2.60315 -548 2 9.16152 15.1411 1.43932 5.44244 -6.16758 -2.29782 -549 2 7.78914 14.5375 1.12422 -1.25934 1.00196 -2.01266 -550 1 15.531 1.37665 7.20033 20.0832 14.6351 13.3031 -551 2 14.8916 0.843079 6.76136 -18.4007 -14.9103 -14.8508 -552 2 15.066 2.19014 7.43626 -3.82192 3.26637 1.54172 -553 1 5.03616 12.9919 18.445 -16.5564 -3.92778 -1.34985 -554 2 5.49952 13.0651 0.633359 3.65082 -0.909975 11.8673 -555 2 5.58799 13.4788 17.838 5.35286 -1.67587 -4.32886 -556 1 15.4004 8.57696 18.1096 -13.5133 -17.3986 23.7812 -557 2 15.6963 9.177 17.4428 12.1428 17.8023 -17.443 -558 2 15.2132 9.11981 0.25138 2.83515 1.87454 -5.46736 -559 1 12.0742 3.0873 18.3015 -13.0771 12.9456 1.32203 -560 2 12.4416 2.71193 0.467697 5.19488 -4.15516 -6.31478 -561 2 12.3414 2.59119 17.5164 7.34103 -8.20972 9.84797 -562 1 13.1603 12.6784 5.14975 4.6094 5.88635 0.276196 -563 2 13.6665 11.971 4.72065 -1.49243 -3.38503 8.68718 -564 2 13.2851 12.6103 6.1136 1.29016 -0.295852 -5.09341 -565 1 6.06548 7.22062 0.130395 -10.0215 14.1887 -9.78073 -566 2 5.90478 8.1622 -0.126677 10.3505 -23.4507 13.8616 -567 2 5.20282 6.91875 0.452817 7.86884 -4.47391 0.318594 -568 1 17.6551 15.8705 14.9463 -5.31761 6.83655 -25.2986 -569 2 16.721 16.066 14.8837 -6.35164 3.20497 21.4179 -570 2 17.8286 15.8261 13.9944 18.3936 -6.902 3.79502 -571 1 13.1598 0.895115 16.6829 -10.2787 13.0231 -1.21317 -572 2 14.0985 0.838925 16.8484 11.7714 -2.60716 3.82434 -573 2 12.9094 -0.0108285 16.49 -7.09766 -5.67505 2.02872 -574 1 10.9245 14.5193 7.39494 -10.4099 -10.8827 23.6465 -575 2 10.1209 14.2503 7.91799 23.546 5.98273 -19.3945 -576 2 11.6246 13.8906 7.65805 -5.45953 8.29317 -8.96944 -577 1 17.5666 8.45977 2.1077 -2.45541 -18.4017 -7.84499 -578 2 16.6916 8.4078 2.54921 14.2221 -0.924117 -8.74119 -579 2 17.6058 7.68446 1.4828 -2.53767 24.5137 15.8214 -580 1 12.3693 7.85876 1.99742 11.9287 1.39128 11.652 -581 2 11.9574 8.70597 1.81668 -2.84663 4.1279 -5.57453 -582 2 12.0661 7.22941 1.33154 -5.87406 3.00715 -1.1515 -583 1 12.0244 14.6632 10.3909 28.0505 -1.98221 6.53788 -584 2 12.2154 13.9026 9.84664 0.841551 -5.23881 -6.52272 -585 2 11.0973 14.8027 10.3697 -37.2752 0.615569 -5.61626 -586 1 6.83101 6.95959 15.54 -26.922 -25.3261 -7.84618 -587 2 7.74646 6.93869 15.3131 28.0025 5.72032 -4.23149 -588 2 6.70706 7.70294 16.1074 0.47288 18.1258 13.2198 -589 1 7.99181 4.56873 13.323 -17.7662 10.8645 -2.94772 -590 2 7.11502 4.75523 12.8947 23.3848 -2.11675 2.9311 -591 2 8.34221 5.42155 13.6369 -8.03699 -10.5621 -3.57795 -592 1 13.4097 12.1854 14.3195 -5.65215 6.28756 1.83858 -593 2 13.0403 11.2921 14.2436 5.24433 -3.00833 -1.58816 -594 2 13.8498 12.3732 13.4771 -2.55607 -2.02901 -2.35573 -595 1 14.6454 9.43305 7.28195 10.7596 15.6461 6.41649 -596 2 15.5174 9.89596 7.36949 -20.7431 -7.51972 6.68313 -597 2 14.0059 9.84843 7.89782 12.5114 -5.65293 -10.9965 -598 1 12.693 16.9181 3.21868 4.13721 -47.3842 -7.97708 -599 2 12.7878 17.338 4.04875 4.47204 15.8163 32.4195 -600 2 12.4838 17.5994 2.61833 -10.0532 31.8516 -27.8744 -601 1 1.00841 7.13021 17.3596 12.9632 -6.47488 11.204 -602 2 0.140567 7.22584 17.7618 -2.41623 -7.13214 2.78808 -603 2 0.956632 7.61621 16.5408 -0.0488819 7.87685 -11.8994 -604 1 12.917 4.94058 15.6965 -33.9833 6.00302 -1.61153 -605 2 13.6432 4.4005 15.9475 28.608 -13.7192 2.54357 -606 2 13.1955 5.85458 15.7909 9.71851 9.87704 0.635703 -607 1 2.3887 3.3689 5.15584 14.955 -15.9692 -52.0278 -608 2 1.80093 3.08916 5.81858 -25.593 -10.9876 33.4797 -609 2 2.79381 4.15677 5.46164 14.8077 31.4017 13.6729 -610 1 8.27435 11.0395 13.6153 -37.0795 23.6732 -65.6931 -611 2 8.36475 10.9269 14.5167 14.9976 -12.7369 63.1872 -612 2 9.08207 10.7919 13.1709 13.5323 -11.5041 2.55762 -613 1 12.9711 1.50053 13.2758 -7.16838 -21.0368 21.1096 -614 2 13.525 1.50324 12.5105 16.6349 2.94139 -20.1138 -615 2 12.6114 2.3778 13.3258 -6.20414 13.0805 -2.33086 -616 1 6.55993 13.5741 2.17335 4.5265 3.63418 -23.4358 -617 2 5.93511 13.8533 2.83279 -12.7543 7.85744 13.7798 -618 2 7.20659 13.0527 2.65116 1.25385 -4.10852 0.808212 -619 1 15.8831 6.47501 12.6409 22.0814 4.72601 -0.603906 -620 2 16.4738 6.98335 12.028 -14.2245 -11.2946 14.6347 -621 2 16.3705 6.43226 13.5009 -10.5632 5.96191 -15.5708 -622 1 16.8031 0.705923 9.56407 -2.28595 11.5891 -8.26827 -623 2 16.6552 18.4511 9.84906 2.3526 -17.7501 5.98934 -624 2 16.3731 0.773302 8.69375 1.62838 3.03603 0.698224 -625 1 6.10625 11.6157 8.28914 -3.08711 55.9701 7.34602 -626 2 5.36711 11.2964 8.79127 -16.3164 -7.54559 6.80515 -627 2 6.5283 10.8686 7.94164 19.8706 -42.6353 -12.8098 -628 1 2.81358 8.70539 0.376179 36.8039 -5.08598 16.3747 -629 2 2.33554 8.23944 18.3571 -22.6922 -9.90678 -17.9478 -630 2 2.28148 9.42572 0.700092 -14.5476 7.98537 3.82577 -631 1 10.114 10.4289 6.56839 -5.48816 -6.21666 7.2072 -632 2 10.5648 9.70982 7.03635 1.99723 -0.0329781 -1.13968 -633 2 10.3487 10.347 5.64237 7.8387 0.67993 -6.97128 -634 1 6.81211 15.7679 6.65103 -0.348958 5.58939 -1.23617 -635 2 7.12762 16.1335 7.48534 -0.336507 -3.46393 3.99871 -636 2 7.12562 16.4168 5.9986 -1.75978 -6.48118 -4.29666 -637 1 6.49059 12.9347 5.74014 0.722488 11.3509 6.39713 -638 2 6.52544 13.8593 6.05125 4.61742 -7.45139 -3.43251 -639 2 6.13117 12.4341 6.48422 -0.637044 1.07223 -0.836688 -640 1 16.7722 12.5296 9.75372 -10.3378 8.80589 22.9139 -641 2 16.9709 11.8837 9.07779 5.41942 -3.21474 -11.15 -642 2 17.3199 13.309 9.62307 0.866334 -2.28521 -6.10033 -643 1 6.18734 2.89369 2.76381 6.70118 21.5641 -20.0406 -644 2 6.53969 3.77128 2.46465 -8.05809 -16.0544 14.4298 -645 2 5.6766 2.59589 1.99155 1.09601 -8.68373 7.94101 -646 1 10.8178 3.09588 3.24672 1.33393 -8.05069 0.148042 -647 2 10.2056 3.80475 3.46561 0.323029 3.07521 -1.63087 -648 2 10.3998 2.55919 2.55618 -0.935454 8.00813 2.52947 -ITEM: TIMESTEP -70 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.83052 6.78564 17.8747 4.81039 14.7119 7.93216 -2 2 8.02044 7.08583 18.306 -2.95347 -6.04078 -1.17349 -3 2 8.57794 6.09723 17.2713 -4.49598 -11.7014 -7.63976 -4 1 0.124161 8.31212 6.74558 -2.09679 -1.27724 -21.4903 -5 2 0.320991 8.02726 5.80661 -3.30063 7.0305 29.7013 -6 2 0.593986 7.72695 7.35611 1.84479 -1.64007 -4.64643 -7 1 8.55341 0.214487 6.89794 4.20955 -4.60902 11.3327 -8 2 9.45965 0.255338 6.58274 3.95615 -0.229119 -0.443755 -9 2 8.09377 0.850204 6.35793 -6.3823 8.35705 -5.64785 -10 1 6.52177 1.69631 11.7106 -29.0447 -4.52087 -3.66773 -11 2 5.85029 2.25877 12.1616 13.2184 -10.2105 -7.98022 -12 2 6.00884 0.936302 11.3174 15.6542 21.0994 14.986 -13 1 6.92822 5.5902 2.37948 23.4336 -17.8876 -5.1013 -14 2 6.5261 5.8779 3.18071 -18.514 8.45901 19.042 -15 2 6.74676 6.28055 1.75003 -1.36947 6.04298 -15.8103 -16 1 16.1916 10.2374 16.1412 -24.0328 -6.0953 4.14694 -17 2 17.0138 10.497 15.7581 19.6671 8.99174 -7.62884 -18 2 15.6617 11.0456 16.2513 11.6446 -5.87426 0.419849 -19 1 10.7179 14.9528 2.30402 9.26606 5.76352 20.4147 -20 2 10.604 14.349 3.06349 2.85769 5.88214 -5.84145 -21 2 11.1755 15.7297 2.69585 -5.79349 -8.7688 -7.8832 -22 1 17.1683 8.21322 10.7989 1.82063 -1.23871 -1.95171 -23 2 16.5117 8.80699 11.1832 -0.385781 3.51193 7.00123 -24 2 17.9642 8.75858 10.6912 0.976865 0.382705 -5.65698 -25 1 14.6466 15.9322 16.4418 -21.6809 -6.01765 9.50279 -26 2 13.7097 16.2329 16.4085 18.6708 -4.64396 -3.84163 -27 2 14.6751 15.3815 17.2568 4.92661 10.5457 -14.6576 -28 1 12.1005 13.348 0.567693 14.0677 -11.0124 3.49805 -29 2 11.7977 13.4785 18.3054 -3.25303 6.53047 -2.60123 -30 2 11.7369 14.0166 1.16546 -7.92056 -0.136763 -7.41856 -31 1 9.34615 5.48792 3.88275 21.7787 0.248377 2.40385 -32 2 8.84331 5.37966 4.67443 -9.14 -4.08483 27.4632 -33 2 8.65688 5.52523 3.23949 -14.702 1.76912 -26.3373 -34 1 1.6606 4.00652 11.6035 4.04251 -10.384 -6.17332 -35 2 1.67583 4.94617 11.8049 -2.44143 11.0832 5.72027 -36 2 2.2695 3.55993 12.2146 -3.92557 1.72629 -0.38872 -37 1 2.08139 6.85853 8.20375 5.25116 9.81515 7.60897 -38 2 2.56831 7.24635 8.96213 -7.90159 -5.93168 -10.5698 -39 2 2.00199 5.91426 8.39105 -0.650687 0.0621593 5.33933 -40 1 5.36768 4.45674 7.91405 -3.32795 5.87339 3.17518 -41 2 5.46396 3.51228 8.0104 5.66802 -14.4695 -1.12836 -42 2 4.78412 4.56623 7.16078 -4.98903 9.02084 -4.56071 -43 1 3.31193 2.91026 17.4243 5.25503 -22.5991 -0.535021 -44 2 3.97925 3.43469 16.9765 8.2555 0.833912 -8.18173 -45 2 2.82292 3.51814 17.9594 -9.74498 21.4045 11.9966 -46 1 7.44628 5.47686 6.16962 4.83779 4.18627 -38.8589 -47 2 7.80337 6.02378 6.84422 19.7966 19.2933 17.1246 -48 2 7.08839 4.74785 6.63594 -15.5951 -22.4752 14.0992 -49 1 9.79841 6.99298 12.0115 -14.4173 0.175621 -19.7413 -50 2 10.2338 6.25953 11.5352 -7.27244 10.6531 4.67439 -51 2 9.07403 7.33711 11.4082 20.5779 -11.7539 16.8314 -52 1 14.0932 3.73018 8.11294 -2.35225 21.206 2.79521 -53 2 13.7164 4.53948 7.70027 6.06412 -15.1972 7.35067 -54 2 14.2932 3.96864 9.04107 -1.96145 -2.4542 -11.4015 -55 1 4.4865 17.2305 3.91995 2.87421 -17.2964 21.8602 -56 2 5.37817 17.5632 3.85852 13.1015 6.2627 -4.15101 -57 2 4.01126 17.4425 3.12603 -6.70645 13.3364 -16.7923 -58 1 16.3503 16.556 10.4027 -28.8153 -10.9362 -6.11544 -59 2 15.5262 16.5238 10.94 14.5825 4.08322 -8.19499 -60 2 16.0782 16.1167 9.56389 6.69544 5.4961 14.7824 -61 1 2.00781 4.81695 0.19428 -16.7794 -3.94444 -13.379 -62 2 2.36068 5.21925 0.976813 15.1603 4.4174 16.1734 -63 2 1.77343 5.5764 18.2905 0.379182 1.41768 -5.2961 -64 1 11.3582 13.2716 16.3898 -3.93488 16.8957 9.12151 -65 2 10.9039 12.4355 16.5285 -2.10099 -6.82713 -1.65452 -66 2 11.9323 13.1324 15.638 7.04428 -4.38588 -8.74921 -67 1 10.1365 10.938 16.8467 -2.82235 24.3376 4.32555 -68 2 10.5718 10.0987 16.7812 6.05632 -17.4389 0.305733 -69 2 9.20542 10.7786 16.7086 -10.6888 -4.42603 -1.21793 -70 1 11.8139 17.4685 13.4625 16.8497 6.47801 1.45884 -71 2 12.3399 16.8066 12.9857 -2.09189 7.12722 0.625626 -72 2 12.305 18.316 13.3535 -13.8327 -6.90215 0.736174 -73 1 6.44924 9.38958 12.2401 6.69888 0.367183 -15.9058 -74 2 7.02028 9.14259 11.4734 -10.412 6.11649 20.9521 -75 2 7.00474 9.9221 12.8226 3.16796 0.0903621 -0.913647 -76 1 16.2861 12.8631 2.69282 -5.5095 27.1919 6.93721 -77 2 17.1297 13.3403 2.5399 -11.4064 -12.6315 1.20497 -78 2 15.6248 13.5969 2.82884 15.7371 -22.5818 -6.03687 -79 1 0.705842 12.6958 5.89372 11.1118 0.602373 24.8353 -80 2 1.18521 12.4959 5.09265 -4.47491 1.87676 -19.0631 -81 2 18.418 12.5564 5.72922 -11.8137 -1.703 -8.70405 -82 1 5.28198 16.3804 18.4185 -2.246 1.3069 9.83982 -83 2 5.62966 15.5825 18.0261 2.19299 -6.30074 -9.03385 -84 2 5.78103 16.4802 0.590407 -0.738213 6.24336 1.72583 -85 1 0.669378 7.71651 4.13384 -59.2278 -40.1014 26.2385 -86 2 0.0696389 8.03317 3.4616 -5.2936 5.59306 -12.1338 -87 2 1.48105 8.07531 3.93226 66.8664 27.2164 -22.0097 -88 1 3.17848 8.98449 6.48797 -11.6429 31.0556 -28.5774 -89 2 3.69754 8.52221 7.10624 17.5545 -20.4274 28.0681 -90 2 2.28321 9.06095 6.81713 -8.12873 -6.01142 5.66961 -91 1 7.27057 10.3561 16.259 12.8547 -0.986094 -7.05958 -92 2 6.52139 10.8488 15.9387 -6.88577 4.52419 -2.25862 -93 2 7.07809 10.1849 17.1799 -5.89204 -3.21212 7.89434 -94 1 11.0493 0.926342 5.00492 7.6282 -0.312775 10.2028 -95 2 11.2745 1.78939 4.63491 -8.49938 0.0964505 -4.50291 -96 2 10.791 0.378052 4.25157 -0.730025 2.38059 -0.222793 -97 1 4.31171 2.85627 13.1955 -2.92819 26.6809 -11.7177 -98 2 4.37585 3.38692 13.9969 4.42074 -3.40265 4.05123 -99 2 4.21422 1.95476 13.4751 -3.58996 -22.8444 6.9477 -100 1 8.4068 10.257 1.78795 4.04191 -13.9705 -5.37842 -101 2 8.26785 10.8775 2.49552 -4.14797 15.7472 11.4003 -102 2 8.5529 9.42866 2.25521 3.43453 -4.46737 -1.06154 -103 1 10.2803 1.70096 15.4762 8.76071 -4.61575 -1.32446 -104 2 11.1657 1.41822 15.7142 3.10462 2.167 2.36838 -105 2 10.3075 1.82832 14.5156 -8.33356 3.27592 2.91474 -106 1 2.63173 12.8085 7.89063 4.0959 -9.21484 -0.859497 -107 2 3.2295 13.3973 7.41028 -2.49756 4.22571 1.84267 -108 2 1.98308 12.5062 7.24287 -1.99659 4.67741 -0.497136 -109 1 3.82895 11.7184 5.01628 -2.65331 8.28036 11.6201 -110 2 3.66291 11.1157 5.74556 0.426771 -3.98214 -1.1075 -111 2 3.01542 11.7805 4.50368 -0.128738 -0.0731644 -2.81963 -112 1 6.76514 14.4734 16.965 3.61018 3.02569 -11.8589 -113 2 7.44445 15.1431 17.0872 4.2046 -3.50831 2.36163 -114 2 6.5725 14.4959 16.0119 -5.95898 4.08629 6.49151 -115 1 14.2172 14.5156 3.23512 -15.7654 4.80027 20.0484 -116 2 13.9157 15.4376 3.23841 -0.320177 -6.15912 -4.56224 -117 2 13.7912 14.1249 4.0321 9.04818 0.126488 -15.8424 -118 1 8.62194 18.1001 16.0659 -23.21 2.71751 -2.03066 -119 2 9.16623 17.3958 16.3546 8.59431 -35.107 8.94544 -120 2 9.24682 0.159724 16.0687 7.59352 33.2076 -10.3682 -121 1 4.64785 1.66473 4.88429 20.0976 -32.3539 12.8345 -122 2 3.91841 2.23972 4.98678 -27.2909 21.6553 1.42112 -123 2 5.29938 2.12424 4.3745 8.75708 11.4615 -15.3566 -124 1 14.996 12.6195 16.4803 11.4842 8.30008 2.93566 -125 2 14.5677 12.8295 17.3315 -5.03395 -0.949445 -14.8823 -126 2 14.3989 12.5973 15.7101 -8.95177 1.91572 10.2236 -127 1 15.728 18.434 16.8656 -21.8007 21.3443 -35.9839 -128 2 16.2692 18.4514 17.6234 28.2096 -0.560819 33.2727 -129 2 15.2446 17.617 16.9069 0.184765 -20.6285 -2.2654 -130 1 1.36479 1.27889 16.6468 -16.7944 -10.044 -5.49533 -131 2 2.14801 1.79564 16.8219 8.14362 6.44014 2.70449 -132 2 0.693336 1.65446 17.2331 2.17778 -0.49248 0.882874 -133 1 18.205 4.38071 15.9717 -12.5383 1.08179 -4.34425 -134 2 17.9247 3.87865 15.1967 2.33887 0.121173 2.56773 -135 2 0.514445 4.3883 15.9876 8.17504 0.178033 -1.34417 -136 1 12.1632 17.0104 16.1415 17.8243 8.47052 -8.26904 -137 2 11.4339 16.4838 16.4748 -11.8796 -0.396392 0.7857 -138 2 12.1013 17.0682 15.1696 -12.6199 -2.93135 7.53111 -139 1 16.1201 2.6287 18.1864 3.80406 -3.99791 19.9987 -140 2 15.7935 3.50022 18.4009 -8.69312 10.1277 7.25942 -141 2 15.8264 2.47036 17.3057 -5.74882 -3.05042 -27.5508 -142 1 6.63908 13.8237 10.1059 1.54133 -19.2408 -0.896874 -143 2 6.60488 13.4547 10.9999 -2.4531 4.12781 1.41157 -144 2 6.6237 13.027 9.53669 -1.978 12.9815 -0.0933135 -145 1 10.1367 18.5192 2.71126 14.9692 1.08893 5.4249 -146 2 10.5375 0.290475 1.93143 -3.72697 -2.23961 5.76435 -147 2 9.31873 18.1319 2.42821 -14.2623 -5.70844 -7.57952 -148 1 3.05388 17.7183 6.14163 -17.3097 -9.85118 -22.5426 -149 2 2.24205 17.5791 5.58071 14.4512 3.50974 23.581 -150 2 3.73807 17.7208 5.46344 2.0394 5.03095 2.09251 -151 1 12.6118 16.8054 7.95495 4.58219 1.15158 -10.9791 -152 2 11.8555 16.2225 7.90842 -7.26482 -13.9478 -6.78863 -153 2 12.3849 17.4156 8.64585 -0.135632 15.5831 16.1371 -154 1 14.8975 15.2817 8.22586 -10.0433 25.2404 1.15436 -155 2 14.1016 15.8482 8.35876 13.2826 -12.9576 -5.35538 -156 2 15.2902 15.6258 7.39629 -1.79461 -13.1873 12.9757 -157 1 17.8242 18.245 0.290753 35.0262 5.69882 -22.3559 -158 2 18.562 17.7688 18.4584 -26.5201 3.44978 21.3008 -159 2 18.2553 0.461923 0.458274 -15.0979 -6.94564 5.00195 -160 1 0.811942 10.4929 1.40956 8.77271 16.3938 -17.0751 -161 2 0.0922351 9.87336 1.50209 -12.9574 -8.99075 8.33498 -162 2 0.506251 11.1761 0.770938 6.09002 -9.92994 11.4815 -163 1 1.80057 12.2567 3.3157 -0.00821892 -5.58838 -28.0373 -164 2 1.51905 11.5718 2.65287 2.57103 10.7079 19.8708 -165 2 2.13035 12.9839 2.7472 -5.7627 -4.92842 11.1942 -166 1 0.668516 17.2609 4.94683 -35.85 3.98858 25.1078 -167 2 0.0697466 18.0029 5.19004 17.5579 -5.46754 -17.9658 -168 2 0.309089 16.5456 5.51301 20.6369 3.3795 -13.3957 -169 1 1.1258 0.902495 9.33726 -12.4564 -3.06084 39.8122 -170 2 1.2842 0.722879 10.3134 -2.51149 4.27857 -26.5162 -171 2 0.280567 0.461704 9.18062 1.78742 1.97705 -4.09399 -172 1 16.751 2.38387 13.3212 3.93571 18.018 2.1702 -173 2 16.8889 2.64612 12.3995 3.13812 2.89192 3.07637 -174 2 16.5572 1.45381 13.2916 -4.67688 -18.3777 2.25645 -175 1 2.721 15.8932 12.0356 -10.4038 6.64935 25.1991 -176 2 2.99704 15.5189 12.8835 -2.56405 3.43208 -4.36032 -177 2 3.3254 15.553 11.3859 5.26998 -2.53603 -11.8474 -178 1 16.4132 15.6174 6.13158 -30.6236 -31.2218 7.18947 -179 2 17.2889 15.5331 6.46785 25.936 1.45578 4.51193 -180 2 16.388 16.3213 5.51027 2.55474 24.6255 -21.834 -181 1 5.75165 5.17156 11.8076 -10.0158 20.8309 8.83951 -182 2 5.58328 6.03799 12.2608 0.394348 -20.1746 -10.5178 -183 2 4.95414 4.6515 11.9927 8.5068 -2.87995 -2.26002 -184 1 15.1308 4.87532 0.804768 27.2949 -1.75024 -19.8676 -185 2 14.8777 4.72649 1.70618 -7.53991 -8.08598 20.9925 -186 2 14.4372 5.36761 0.397065 -18.333 11.5318 -5.57633 -187 1 16.3608 16.424 1.96087 0.545069 28.5814 -7.81874 -188 2 15.9402 16.8572 2.72963 9.40909 -7.94755 -2.88814 -189 2 16.7928 17.1706 1.4719 -7.75465 -17.4072 6.82817 -190 1 0.195497 4.8427 3.9016 -20.8114 -16.3238 -7.36148 -191 2 0.347935 5.77048 3.88737 2.90582 31.823 0.953261 -192 2 1.01225 4.48793 4.21241 18.9183 -15.2676 9.08502 -193 1 2.99687 15.0761 15.1729 -7.80035 25.004 -19.9303 -194 2 2.75027 14.6107 15.9518 -1.28992 -16.7566 29.7079 -195 2 2.55205 15.9391 15.3182 6.19364 -5.6546 -9.94962 -196 1 1.13925 14.6508 9.53021 19.9076 23.5081 3.98588 -197 2 2.07639 14.8825 9.77663 -29.323 -13.131 -7.88186 -198 2 1.04812 13.6993 9.55892 5.54263 -6.82879 4.76298 -199 1 13.5171 16.5199 11.5195 20.4201 8.76324 22.1576 -200 2 12.9867 17.257 11.2155 -0.855064 7.64635 -14.0191 -201 2 13.0442 15.7467 11.2378 -7.08331 -12.4379 -10.7884 -202 1 4.66723 1.48136 0.73322 23.0149 3.26353 10.1864 -203 2 3.99044 1.945 0.247475 -7.51763 5.99594 -9.81004 -204 2 4.21698 0.879204 1.33273 -6.6714 -6.19828 -5.18082 -205 1 1.48126 18.5865 11.8932 5.77456 11.9109 13.6761 -206 2 1.45047 0.509997 12.7065 -0.655319 -12.4833 -18.3988 -207 2 2.16842 17.9125 12.0331 -8.54366 2.69761 2.01722 -208 1 11.4638 10.1444 4.04596 -29.9846 -9.43843 22.7531 -209 2 11.586 10.5695 3.21678 -1.49335 12.1472 -28.3165 -210 2 12.3366 9.99459 4.35585 30.6386 -4.62302 8.08877 -211 1 8.15809 12.1698 3.75544 16.5318 -12.8496 -25.3624 -212 2 9.0168 12.5594 3.97136 -0.0903232 2.9732 11.2136 -213 2 7.55758 12.2779 4.48666 -4.55936 7.15494 21.2951 -214 1 14.57 4.03338 3.33424 -15.9396 -3.34089 -13.9779 -215 2 15.2475 4.30951 3.93522 14.2067 0.133456 17.245 -216 2 13.7488 4.35662 3.71839 -4.37522 2.77806 -1.52286 -217 1 5.69573 1.64484 7.55416 47.4861 32.5669 -28.9041 -218 2 5.02314 1.22164 8.01158 -49.1519 -34.4826 29.3881 -219 2 5.51675 1.48645 6.61188 -4.44278 2.0561 3.75596 -220 1 17.8757 1.08291 4.8338 -2.11434 0.172647 4.71576 -221 2 18.4455 1.46692 4.16357 3.67184 -2.89676 -9.33974 -222 2 18.0165 1.6381 5.60499 -0.396504 -0.0112538 6.48923 -223 1 6.85338 9.35555 4.52322 8.01303 -7.73923 12.5712 -224 2 6.71294 9.49068 5.48294 3.02765 -1.76203 -13.5451 -225 2 7.79052 9.06961 4.44068 -13.079 3.18293 -1.46589 -226 1 2.62197 14.8521 2.02937 -10.5221 3.39156 -23.0918 -227 2 3.43005 14.7674 2.51892 12.1264 -2.78802 16.39 -228 2 2.89555 15.1253 1.13827 -2.73698 -5.91865 10.4405 -229 1 17.3299 12.9421 13.1931 -12.7738 17.025 -7.03447 -230 2 16.4383 13.2606 13.4479 14.3464 -2.45707 -5.73497 -231 2 17.7945 13.7546 12.8897 -6.22536 -14.4165 5.27249 -232 1 14.8979 10.5619 1.48982 -11.9525 28.8063 14.5441 -233 2 15.3485 11.4081 1.81139 -13.0513 -30.8314 -8.90843 -234 2 13.9324 10.6539 1.67123 25.3412 1.8999 -4.23485 -235 1 5.67595 6.67872 4.55433 0.362155 18.5292 -10.9955 -236 2 5.7867 7.61135 4.29326 0.453279 -5.37291 7.09585 -237 2 6.40948 6.48302 5.14674 -0.086512 -6.41659 5.49044 -238 1 7.99316 8.32936 10.3099 -9.88556 -13.348 -36.673 -239 2 8.52429 8.77949 9.6279 3.30308 5.35046 16.0689 -240 2 7.32365 7.86355 9.75728 7.50693 2.48224 14.219 -241 1 13.4328 18.4778 5.70681 16.0844 -0.193399 -6.38488 -242 2 12.6986 0.421386 5.55211 -13.5651 7.65576 -7.58054 -243 2 13.084 17.8957 6.37412 -0.0453673 -15.2248 15.7361 -244 1 -0.0111344 2.60704 0.305045 25.2129 -30.2702 8.72131 -245 2 17.7164 2.72495 0.164021 -32.2143 -6.6311 -9.93678 -246 2 0.303096 3.48034 0.225751 24.1306 33.5707 -2.06333 -247 1 12.8325 10.9421 9.75806 8.08682 -36.6012 3.93532 -248 2 11.88 10.8422 9.79419 -10.8426 11.3849 -4.95145 -249 2 13.0795 10.0004 9.94273 0.259667 22.5692 -5.0531 -250 1 0.642026 12.1683 11.0609 4.45464 6.09796 -5.6804 -251 2 18.3356 12.2213 11.2584 6.06715 1.14224 4.76964 -252 2 1.15053 12.4132 11.8471 -8.72956 3.82018 2.8882 -253 1 5.19121 7.35128 13.362 14.2217 -1.26987 2.88721 -254 2 5.71731 8.09811 12.9969 -6.96977 -10.5111 6.72344 -255 2 5.67215 7.04852 14.1611 -4.50302 8.90065 -9.08298 -256 1 1.17753 6.82665 11.884 -6.96202 23.1207 3.27017 -257 2 0.332868 7.13942 11.4836 19.3553 -6.8941 9.30012 -258 2 1.59694 7.61812 12.3119 -7.65201 -17.5731 -13.8958 -259 1 15.4801 9.74186 12.3501 8.02403 -36.537 -7.5848 -260 2 15.2771 10.6331 12.1319 -8.61126 25.0623 0.312061 -261 2 15.6595 9.70704 13.2832 1.37326 2.5629 11.9963 -262 1 16.5169 12.594 5.50965 10.4637 -15.548 10.5874 -263 2 16.3074 13.4879 5.77305 -4.76715 16.3332 -4.64473 -264 2 16.4013 12.5274 4.55501 -3.26126 3.70708 -8.86796 -265 1 6.31292 9.82321 0.0853393 -0.254663 19.8779 15.0366 -266 2 5.47299 10.2624 0.316114 7.63969 -1.93852 0.671735 -267 2 6.95815 10.0698 0.784254 -6.58085 -1.04763 -9.09577 -268 1 12.2316 6.09819 4.0135 -11.5327 11.7492 -3.18772 -269 2 12.1819 6.93481 3.49894 6.0574 -18.2652 4.97925 -270 2 11.3139 5.7855 4.02535 4.75129 -2.10791 -0.415098 -271 1 0.346102 12.8439 0.0895734 -4.86896 0.353582 5.39062 -272 2 18.7507 13.4631 0.799834 -0.48412 -1.67542 -1.66039 -273 2 18.3682 13.0274 18.0218 -2.69393 2.08889 -5.2677 -274 1 3.5489 0.022651 8.64264 14.8213 -2.21723 6.15117 -275 2 3.34146 18.2537 7.79412 -1.37888 1.54429 -1.85278 -276 2 2.69807 0.312924 8.99074 2.91061 0.134312 -8.36673 -277 1 7.48275 17.4677 4.49597 -9.82961 -11.4008 2.47905 -278 2 7.76172 18.3639 4.65831 -0.473756 11.2371 0.709742 -279 2 7.61951 17.3416 3.55584 -1.72206 -2.44101 -5.98946 -280 1 9.27482 17.1419 12.2002 -29.9673 17.8198 -3.75997 -281 2 9.29449 16.2474 11.8858 2.76409 -17.0257 -9.00951 -282 2 9.96887 17.232 12.8306 24.004 1.27191 14.3563 -283 1 13.3881 13.0638 7.94543 23.8544 1.05207 16.0454 -284 2 13.4911 12.3591 8.61055 -7.80977 1.42534 -8.25381 -285 2 14.1677 13.6583 8.10929 -22.3675 -6.64423 -7.05202 -286 1 14.8196 2.98416 15.4059 10.9247 4.82989 11.3692 -287 2 14.1977 2.30622 15.182 -14.8004 -11.8419 -2.86461 -288 2 15.3715 3.04555 14.6288 11.3419 0.403673 -8.50968 -289 1 9.89007 15.644 16.9507 -0.476448 -13.1737 2.9886 -290 2 10.2689 14.811 16.6236 0.33136 1.14394 -2.50282 -291 2 9.50974 15.3862 17.8064 -0.51987 6.75584 -0.702029 -292 1 11.2404 8.49746 16.6126 -11.0388 -24.1902 -5.6141 -293 2 10.5493 7.95233 16.1656 11.7734 11.5748 6.95591 -294 2 11.5411 7.95338 17.3605 -0.459906 4.27214 -6.12679 -295 1 3.94653 18.1828 16.8275 -12.5536 19.575 -10.0724 -296 2 4.49583 17.6028 17.3635 4.26127 2.6886 8.36922 -297 2 3.95977 0.456308 17.1729 5.72776 -19.9128 0.46306 -298 1 2.2132 4.22212 8.91052 -3.52394 3.62108 -17.0138 -299 2 3.14576 4.09878 8.74947 8.67559 -2.34434 0.767855 -300 2 2.06536 4.03466 9.83165 -0.817379 -1.75645 17.2153 -301 1 9.87247 10.3712 9.74928 14.7683 -30.296 -5.49075 -302 2 9.62147 11.2221 9.45607 -13.6864 32.2476 -14.4563 -303 2 9.99394 10.4206 10.6874 0.365841 -1.43755 21.5864 -304 1 9.68376 0.92477 10.8522 -9.86416 -7.8375 -9.37303 -305 2 9.18791 0.169256 11.2055 11.1043 -0.796798 3.35444 -306 2 9.09399 1.23638 10.1435 10.2069 6.90097 4.69651 -307 1 9.16769 15.091 10.1956 22.4355 7.87639 6.21774 -308 2 8.9696 15.9691 9.88131 -3.17938 11.9605 -8.33522 -309 2 8.32743 14.6622 10.1389 -19.5916 -16.662 -1.08184 -310 1 0.85922 9.69743 10.2442 32.6336 -47.5631 -25.4673 -311 2 1.02374 10.6105 10.3992 -2.53948 25.7241 9.50189 -312 2 1.72313 9.35148 9.87448 -35.4256 9.68482 16.6576 -313 1 17.0256 4.81986 8.08308 31.6348 -31.2729 -9.48192 -314 2 16.3215 5.37214 8.33224 -31.3655 27.4802 10.3117 -315 2 16.9319 4.0155 8.6004 0.768816 2.34372 -1.45333 -316 1 14.8081 14.6794 0.153243 -2.85725 -11.5952 -11.9613 -317 2 15.2092 15.2804 0.771003 11.383 9.73034 15.7651 -318 2 14.0408 14.3115 0.591288 -7.92269 -3.99881 6.06231 -319 1 3.80416 11.0019 9.56526 0.623941 6.68377 2.11405 -320 2 3.77619 11.4642 10.4186 -0.043788 -6.16761 3.62327 -321 2 3.31763 11.5705 8.95624 -4.54045 6.84371 -3.4313 -322 1 11.3158 10.7476 1.45776 10.9951 -9.43983 2.74041 -323 2 11.5252 11.5694 1.01773 6.8042 14.5185 -3.76913 -324 2 10.3718 10.6573 1.35733 -14.9091 -3.38451 -2.45366 -325 1 13.1832 7.19978 12.6897 5.92706 -14.8401 5.32281 -326 2 14.1145 6.87754 12.7085 -13.0936 9.37511 -3.26372 -327 2 12.6462 6.38983 12.7968 5.91866 7.22274 -2.53959 -328 1 9.61767 1.88189 0.936979 -6.6056 8.12678 -33.3335 -329 2 8.75647 1.76915 0.468433 15.5153 -2.73343 13.4493 -330 2 10.2273 2.17983 0.230861 -6.38326 -0.489196 14.1696 -331 1 10.6523 13.47 4.56634 -17.7163 6.61907 -5.84307 -332 2 11.5562 13.1849 4.68206 11.5009 -9.86279 4.07703 -333 2 10.5151 14.0877 5.29021 -1.44258 0.681598 7.9468 -334 1 14.5213 1.69385 10.9785 0.412416 12.5139 1.3055 -335 2 15.3159 1.33414 10.5754 1.96072 -4.24727 -0.900333 -336 2 14.7412 2.63918 11.0728 -6.13642 -3.41388 -3.76294 -337 1 14.5042 12.0777 11.6111 -12.2061 0.510996 31.5423 -338 2 15.1827 12.4648 11.0978 29.2487 15.6657 -21.0239 -339 2 13.909 11.6953 10.9807 -16.843 -4.29027 -12.6849 -340 1 8.18401 5.11068 9.87002 -0.676892 -7.65738 -3.35075 -341 2 7.33939 5.06675 10.3357 0.521056 4.21206 1.1001 -342 2 8.29842 4.21721 9.50312 -0.00697362 5.6522 3.71152 -343 1 1.5768 16.9623 18.4443 13.7844 -6.06932 -11.1938 -344 2 2.08688 17.3314 17.6994 -1.29344 -1.55823 6.9248 -345 2 1.72478 16.0021 18.3853 -4.19272 5.84443 -4.03385 -346 1 1.47359 17.3466 15.3156 -41.3862 18.9515 21.4522 -347 2 1.38751 18.1942 15.8376 11.356 -22.4463 -17.1221 -348 2 0.531998 17.0202 15.2731 27.9598 4.08453 -2.72162 -349 1 3.56251 5.80266 6.06315 1.23781 -30.1986 0.952301 -350 2 2.9922 6.42371 6.50913 -3.22231 11.6367 6.59476 -351 2 4.22501 6.28135 5.5614 1.05528 7.23928 -6.44245 -352 1 12.5723 9.4951 14.2463 -14.1947 49.7353 4.36555 -353 2 12.9086 8.77822 13.7576 17.8642 -40.1771 -16.3075 -354 2 12.2963 9.16979 15.1004 -1.36164 -11.5003 11.0357 -355 1 4.07044 15.2648 6.99086 -8.22484 -15.5272 10.3185 -356 2 3.65725 16.0904 6.74002 -9.77102 8.77549 -2.61135 -357 2 5.00026 15.4315 6.88928 20.0063 2.47059 -3.54324 -358 1 0.744606 8.73408 15.0763 0.0218964 -5.95646 -3.10884 -359 2 0.519262 9.66197 15.1074 -7.84082 12.7234 2.89932 -360 2 1.47025 8.73132 14.4431 5.87969 -4.51966 -2.6491 -361 1 12.9306 8.27919 10.1905 8.08936 2.40022 19.7343 -362 2 13.779 7.90886 9.87037 -9.22858 -4.32337 9.26771 -363 2 12.8604 8.07471 11.1624 7.69549 -2.50096 -25.1681 -364 1 15.3235 7.85492 3.5497 18.4153 32.411 -54.1913 -365 2 14.4745 7.6657 3.15314 -16.0822 -13.4855 9.94503 -366 2 15.5116 7.64082 4.44166 -12.2255 -21.7424 34.152 -367 1 17.2256 6.71185 18.6385 13.0601 3.46678 -1.24204 -368 2 16.7837 5.9846 0.423329 -10.4159 -11.046 2.92977 -369 2 16.5307 7.32814 18.3852 -6.78357 2.8142 -3.2779 -370 1 8.8964 6.96848 7.83902 16.0931 16.0227 -2.80611 -371 2 9.83265 7.28699 7.8278 -17.1093 -4.77101 0.707558 -372 2 8.79691 6.46408 8.64714 -0.939429 -8.3316 9.69843 -373 1 12.4084 0.523138 1.23768 -2.06115 0.0733923 -7.11266 -374 2 13.1872 0.998726 1.54472 7.23891 -2.91784 -1.02165 -375 2 12.4662 0.537618 0.274809 1.69654 -3.93261 2.5223 -376 1 5.65468 15.0902 14.5334 3.02676 -25.5773 -0.125585 -377 2 4.72407 15.1616 14.7961 0.127409 2.72757 -0.91443 -378 2 5.99013 15.9712 14.3886 3.52657 16.2654 -6.40367 -379 1 3.82399 6.39797 1.75512 3.78691 -6.14258 3.26006 -380 2 3.37829 7.15763 1.38654 -6.41374 16.3556 -5.84968 -381 2 3.97609 6.61981 2.67876 -1.82166 -0.0414506 2.69272 -382 1 3.91801 11.4637 12.3808 6.26728 1.11409 -8.60855 -383 2 4.78798 11.8777 12.4982 -7.30712 -3.21292 -1.54071 -384 2 3.30212 12.087 12.775 -5.64928 0.778082 5.20377 -385 1 5.29676 3.85177 15.8189 3.43828 -31.27 -8.27082 -386 2 6.03967 3.23378 15.6029 -11.8461 12.1043 0.727598 -387 2 5.68429 4.70341 15.931 13.0054 23.274 1.41344 -388 1 14.2193 10.1559 4.56622 -21.9238 17.9967 10.7876 -389 2 14.2923 9.81422 5.45847 5.67938 -3.41822 10.3914 -390 2 14.6614 9.51741 4.03067 14.2685 -12.4061 -15.9356 -391 1 7.6994 17.3598 9.13069 2.58566 -7.07749 -1.38218 -392 2 6.9688 17.7373 9.6086 -11.208 -1.02501 12.7072 -393 2 7.91331 18.0249 8.47917 9.78731 5.09099 -13.1281 -394 1 4.50671 14.5226 3.97805 12.528 -25.4608 -46.8355 -395 2 4.48015 15.4086 4.24602 -0.161492 47.21 12.2969 -396 2 4.35306 14.022 4.74858 -6.07017 -24.5156 30.0525 -397 1 14.1411 7.46132 15.8217 -22.5264 -9.25347 -2.17647 -398 2 14.9826 7.35759 15.4044 20.5288 -0.540355 -7.58788 -399 2 14.3421 7.83921 16.6731 3.72262 6.08742 11.7763 -400 1 2.98184 18.372 1.90579 -20.1648 -30.237 -17.2141 -401 2 2.43548 17.7555 1.32026 19.5303 24.385 16.7936 -402 2 2.33791 0.236975 2.41065 -5.95562 0.980031 -0.0237849 -403 1 7.99445 1.58502 4.53075 18.7977 0.504684 -14.6733 -404 2 7.48712 1.99417 3.8192 -9.17378 0.780153 1.87786 -405 2 8.88078 1.50473 4.13387 -7.12077 1.17171 10.2984 -406 1 2.41951 14.1599 17.7056 22.0207 15.2121 -4.13121 -407 2 1.68443 13.6195 17.9516 -15.3327 -12.8663 8.26013 -408 2 3.18525 13.6986 18.0793 5.57496 -0.0710026 -2.65101 -409 1 0.908587 1.85846 13.8858 -0.0793858 -1.94323 14.6669 -410 2 1.14821 1.59902 14.7928 -3.46921 3.66635 -7.67361 -411 2 18.5942 2.00299 13.9058 4.01903 -0.250224 -6.72878 -412 1 4.32702 0.129386 13.8829 -0.0770511 3.08332 3.55447 -413 2 5.24833 18.5067 13.8286 4.90059 -4.64875 -2.30826 -414 2 4.05486 18.5232 14.7746 -2.81766 -1.27361 1.32354 -415 1 7.27357 0.854459 18.3804 -15.3869 4.3045 -1.1218 -416 2 7.16992 0.518993 17.4624 3.36336 5.55626 15.3605 -417 2 6.40185 1.20099 18.6914 11.5657 -10.6186 -10.5297 -418 1 15.9542 18.4046 13.9208 -25.3022 5.029 -14.7602 -419 2 15.0075 18.5254 13.735 13.8644 -2.42428 -4.09563 -420 2 16.0061 18.5076 14.8614 8.67486 -1.51607 21.0166 -421 1 10.2392 4.55204 16.2801 10.7238 -8.25817 -3.6178 -422 2 11.196 4.37813 16.4864 -24.802 4.89259 -9.76699 -423 2 9.86858 3.73489 15.891 10.2726 5.88423 10.0044 -424 1 15.9238 17.7149 4.45644 2.75189 -23.1215 -12.8271 -425 2 16.5168 18.4535 4.47728 14.6813 18.6917 2.39924 -426 2 15.0936 18.0469 4.76398 -21.0845 8.87368 10.3462 -427 1 6.95648 17.503 13.9077 -51.9825 -4.38955 -3.71365 -428 2 7.39002 17.773 14.6913 25.8751 9.72049 29.5532 -429 2 7.60747 17.4983 13.2335 27.2317 -2.92469 -23.3456 -430 1 13.2071 6.48879 6.54043 12.3601 -8.29587 -18.0485 -431 2 14.1818 6.5258 6.42811 -17.7974 6.95191 3.55269 -432 2 12.8555 6.35956 5.62691 5.37067 1.68412 18.5111 -433 1 7.86742 2.30794 9.39626 -5.35093 5.07188 8.74379 -434 2 7.30782 2.2926 10.1983 5.67726 -4.12754 -5.74363 -435 2 7.33716 1.92062 8.69482 -5.03183 0.0809058 -6.36949 -436 1 15.2078 14.7586 13.7432 0.832397 -4.30074 -2.87903 -437 2 14.8858 14.9257 14.6258 -3.94452 3.16733 11.6107 -438 2 14.9517 15.5204 13.2236 -2.78606 2.09491 -5.66724 -439 1 9.4202 8.34719 3.8485 -22.8652 4.71801 -4.87246 -440 2 10.1988 8.89706 3.87201 15.3465 4.97444 3.28263 -441 2 9.69606 7.44575 4.01411 1.53448 -7.03017 -1.02937 -442 1 17.7384 13.5884 16.4052 -11.7067 -11.536 8.32036 -443 2 16.7673 13.5542 16.377 3.38001 -6.87595 1.27552 -444 2 17.9496 14.385 15.9274 3.88108 14.0768 -7.71607 -445 1 4.90559 10.5521 2.87839 21.3367 -20.8737 -11.4011 -446 2 5.623 10.1254 3.38432 -4.07258 6.62764 -8.01418 -447 2 4.62886 11.2624 3.4373 -4.18877 12.0113 9.86562 -448 1 3.72998 8.3995 9.96949 0.206562 0.552242 5.18998 -449 2 3.80623 9.33185 9.71276 -0.050758 -4.34606 1.0469 -450 2 3.86748 8.41721 10.9275 -4.36654 -3.13592 -2.04235 -451 1 15.965 6.95365 5.95266 -6.26742 1.66997 1.55481 -452 2 16.7698 7.37181 6.25298 11.0034 6.69643 7.83926 -453 2 16.2161 6.06091 5.70554 3.02292 -8.38979 0.185448 -454 1 15.1879 7.19538 9.00463 -16.574 -33.0638 16.9279 -455 2 15.9728 7.55664 9.38717 21.7076 13.0833 8.35481 -456 2 14.9649 7.65827 8.21955 0.87619 20.3483 -26.3308 -457 1 6.20656 12.8742 12.7233 -2.45823 6.18764 -5.3718 -458 2 6.79799 12.2543 13.1384 18.4055 -9.75357 3.10315 -459 2 6.13621 13.6122 13.3363 -4.91508 8.57981 5.63651 -460 1 12.128 4.53555 13.1062 -17.5662 -8.78193 22.9206 -461 2 12.3906 4.63486 14.0411 2.44404 0.930561 -9.75427 -462 2 11.3004 4.01263 13.1714 14.0583 8.15169 -11.9376 -463 1 11.4184 8.10098 7.95437 7.14359 -3.91624 -16.2991 -464 2 12.1028 7.60478 7.4673 -7.16754 1.39876 -0.578178 -465 2 11.8093 8.18067 8.82553 -2.79742 2.89488 8.77133 -466 1 17.0514 10.8651 7.58728 -24.1088 0.784299 26.3012 -467 2 17.8144 10.3384 7.41217 20.5663 -15.9736 -11.9321 -468 2 16.8601 11.4269 6.84052 2.19633 6.48519 -17.1676 -469 1 5.231 18.0993 10.8546 26.455 4.8965 -4.82813 -470 2 4.8195 17.6908 11.6007 -11.7048 -9.88744 14.1218 -471 2 4.63699 18.0004 10.1206 -18.4061 3.17503 -16.8763 -472 1 7.59767 17.4436 1.69759 5.72815 6.19172 -16.2775 -473 2 7.89477 16.6568 1.18579 0.971667 15.0969 7.35096 -474 2 7.65141 18.2352 1.10536 -4.88626 -20.2664 5.47735 -475 1 1.93145 12.9234 13.6206 5.60545 -3.12143 -21.3855 -476 2 1.4749 12.3281 14.2061 -8.56587 -7.9862 10.2726 -477 2 2.17547 13.6903 14.1341 4.19375 11.0678 7.71152 -478 1 9.43748 6.79443 14.8327 33.0335 -30.4644 -7.71462 -479 2 9.91196 6.01751 15.25 -19.5648 18.6507 -3.60269 -480 2 9.7502 6.76156 13.9011 -9.65438 10.9618 10.9707 -481 1 15.2831 4.34212 10.7772 21.179 15.7439 -2.01388 -482 2 16.2293 4.27243 10.5111 -19.8675 -5.23 11.4528 -483 2 15.2971 5.09975 11.4021 -5.00612 -14.3562 -6.14057 -484 1 11.351 6.2072 0.109577 23.6613 28.7979 6.66193 -485 2 11.4872 5.27024 0.0694097 -6.21323 -21.6319 -6.22108 -486 2 10.4676 6.44004 18.4761 -18.3883 -9.25121 -2.88973 -487 1 18.5357 11.4228 14.9398 26.7643 -26.8403 31.1109 -488 2 18.0597 11.723 14.1947 -18.2778 17.0129 -29.9513 -489 2 18.4532 12.1424 15.5699 -5.23995 5.81903 4.32114 -490 1 7.05668 9.28071 7.31234 -6.58466 7.4517 -4.55549 -491 2 6.71011 8.47084 7.6978 -4.31789 -6.13087 1.68327 -492 2 7.98804 9.13135 7.18438 15.6823 -2.37616 0.276954 -493 1 18.324 15.3331 12.2569 -7.46978 -1.64803 5.36971 -494 2 0.564477 15.5946 11.9899 10.9599 1.36641 -5.51497 -495 2 17.7284 15.6281 11.5548 0.957946 6.58656 -2.69515 -496 1 16.4958 4.38611 5.25998 2.69003 14.057 -30.634 -497 2 16.6253 3.88668 6.0538 7.32023 -9.57738 16.711 -498 2 17.3371 4.41488 4.75201 -4.14044 -1.60108 11.4247 -499 1 17.7073 3.15256 10.779 -3.63642 -2.40486 -9.15002 -500 2 18.6235 3.40441 10.9111 8.43018 2.88916 7.88185 -501 2 17.7389 2.35032 10.2471 -2.89329 -5.91517 0.580451 -502 1 12.2813 18.6401 10.1181 2.89516 -35.5496 -8.35074 -503 2 11.4703 0.383955 10.4005 -29.8535 10.9583 6.97968 -504 2 12.9196 0.674429 10.2218 25.4798 25.6209 2.989 -505 1 10.3974 9.74216 12.5073 0.112101 -17.0368 -3.21727 -506 2 11.1947 9.82557 13.039 4.39701 4.68697 5.66162 -507 2 10.3035 8.76836 12.4158 -2.37231 15.8308 -1.56525 -508 1 0.663588 2.73535 7.12598 -12.3374 1.53361 -6.62113 -509 2 0.367817 3.62684 7.37457 5.09588 -7.68469 3.80292 -510 2 0.956045 2.28157 7.92852 1.53616 1.67998 2.79736 -511 1 0.311147 15.2759 6.88171 -13.4592 45.4783 4.03261 -512 2 0.500617 15.614 7.76495 4.81164 -9.60864 4.06796 -513 2 0.558697 14.3764 6.88071 13.8097 -37.6199 -4.57419 -514 1 17.0548 6.97395 15.0744 4.20776 -1.94343 -1.58424 -515 2 17.8177 7.57453 14.9855 -5.12063 -2.20736 -0.0554095 -516 2 17.4111 6.17613 15.4934 -0.113823 0.922547 0.618491 -517 1 9.1503 12.5213 8.01319 -14.1189 2.82879 0.278945 -518 2 9.53356 11.9725 7.3299 10.3093 -11.5802 -1.96405 -519 2 8.24075 12.6139 7.71394 -0.988228 2.45183 6.21614 -520 1 1.17609 1.70844 2.83295 3.23913 -2.31621 -1.89882 -521 2 1.09855 2.22978 2.02752 -9.74566 -1.77621 -3.35395 -522 2 1.86202 2.13223 3.34238 5.26299 8.17365 10.1548 -523 1 4.09291 15.1504 9.8922 18.1507 -7.2721 -6.40054 -524 2 4.03036 15.1629 8.92399 -1.00826 2.87435 -0.463193 -525 2 4.99389 14.8146 10.0732 -8.74469 0.915467 -5.31212 -526 1 7.37772 2.25117 14.7222 3.22505 8.21162 1.39777 -527 2 7.09502 1.54536 14.1374 1.57311 -0.181539 -4.41158 -528 2 7.85635 2.90205 14.1691 -14.4419 -9.06063 9.37489 -529 1 18.4006 14.5833 2.15968 -9.78242 8.50711 -1.4388 -530 2 0.62994 14.8842 2.46282 -4.8788 5.17113 -0.292034 -531 2 17.7517 15.3351 2.17575 17.725 -12.6913 0.414249 -532 1 9.99197 2.68277 12.9223 -2.58103 11.7713 -8.17336 -533 2 9.96789 2.1685 12.101 0.346485 -5.49174 3.23624 -534 2 9.29748 3.35451 12.7936 3.47695 -5.23648 4.96996 -535 1 2.96299 8.91941 13.096 19.2939 -0.203164 0.561242 -536 2 3.4486 9.7527 12.8428 -15.067 -18.0348 7.07188 -537 2 3.65865 8.27445 13.3679 -12.9331 14.6867 -6.35999 -538 1 3.26147 8.578 3.77304 6.38222 5.3653 -9.36202 -539 2 3.78874 9.26676 3.32736 -9.65467 -7.00498 -1.39723 -540 2 3.24393 8.8647 4.68594 3.08129 -4.64857 6.90262 -541 1 5.77287 7.24333 8.61048 -1.78661 -5.00814 9.07462 -542 2 5.68022 6.28289 8.53661 4.0016 -1.85755 -4.86386 -543 2 5.00276 7.50215 9.14094 4.61323 4.45406 -2.92895 -544 1 14.8793 1.52937 1.85035 -12.7334 -14.0835 12.9397 -545 2 14.819 2.16152 2.5876 10.8144 6.55959 -13.4181 -546 2 15.5594 1.73936 1.19754 -2.84827 11.2594 2.6977 -547 1 8.5607 15.0611 0.725284 0.46926 -2.1008 2.83341 -548 2 9.29259 14.9147 1.35885 -7.99161 6.01774 -7.32206 -549 2 7.81927 14.5289 1.05772 1.7687 -2.35649 0.826934 -550 1 15.4921 1.3993 7.20702 14.746 2.01238 2.95597 -551 2 14.8484 0.891915 6.72418 -10.4472 -9.96976 -7.88743 -552 2 15.1077 2.27361 7.28199 -8.00989 7.94424 8.07076 -553 1 5.01058 12.9585 18.4386 -15.8567 -4.4202 8.08993 -554 2 5.4193 13.0053 0.667327 2.46468 -0.195888 1.58163 -555 2 5.59523 13.4446 17.8643 8.60291 1.11734 -4.66644 -556 1 15.4019 8.61725 18.0949 -10.0539 -8.80276 13.7753 -557 2 15.8344 9.23888 17.5182 6.53635 7.63687 -15.5634 -558 2 15.1418 9.16559 0.203922 1.58583 0.47418 3.18719 -559 1 12.0525 3.11208 18.2861 7.73999 -14.4321 9.61497 -560 2 12.4007 2.82569 0.495607 -5.57788 10.1171 1.38067 -561 2 12.4066 2.43321 17.7002 -1.56388 4.26076 -9.69121 -562 1 13.1688 12.6857 5.1494 7.31226 -7.20074 3.10637 -563 2 13.4985 11.8462 4.78426 1.65488 6.62932 1.41885 -564 2 13.3525 12.6203 6.1046 -3.90991 6.43934 -4.24709 -565 1 6.08926 7.21668 0.130178 -1.88627 11.2856 16.2629 -566 2 6.12641 8.19603 18.8427 -2.9512 -23.7133 -6.32338 -567 2 5.32645 6.95656 0.679872 3.54107 -2.60359 -10.7249 -568 1 17.6547 15.8703 14.9132 16.2429 2.82715 17.6162 -569 2 16.6953 15.9075 15.0555 4.78919 3.7515 -14.6122 -570 2 17.9345 15.7768 13.9856 -18.469 -1.14955 -2.42085 -571 1 13.1468 0.885591 16.7291 -10.7864 15.024 2.10847 -572 2 14.1008 0.813897 16.7431 10.5998 -4.62802 3.60151 -573 2 12.8375 18.6536 16.4909 -4.88764 -9.34618 2.57866 -574 1 10.8908 14.4992 7.43136 -2.2343 -7.03539 12.0134 -575 2 10.0835 14.2065 7.92308 22.5278 2.1252 -13.3834 -576 2 11.6003 13.8396 7.60224 -11.7269 11.3777 -3.99947 -577 1 17.6181 8.42363 2.12766 -11.9935 -3.6797 -6.77545 -578 2 16.7343 8.37762 2.55285 14.0369 1.72981 -7.6286 -579 2 17.5632 7.81953 1.35766 3.76606 6.32419 13.0143 -580 1 12.3929 7.83138 2.01819 4.71096 17.5308 0.40727 -581 2 12.1717 8.7272 1.7221 -1.13772 -2.1217 4.67191 -582 2 11.9464 7.25327 1.39471 0.282935 -6.68024 -6.10503 -583 1 12.0275 14.6478 10.4009 38.9809 -24.2439 -10.9711 -584 2 12.337 14.044 9.6932 -4.28518 13.1756 12.472 -585 2 11.1105 14.7441 10.2592 -43.0899 4.37787 -4.57767 -586 1 6.8265 6.93238 15.5327 -27.6581 -7.97269 5.64053 -587 2 7.73103 7.08984 15.3178 26.4357 1.09681 -7.32033 -588 2 6.59533 7.63547 16.1384 -2.46814 3.13878 5.80205 -589 1 7.96021 4.51991 13.281 5.98272 36.635 4.98876 -590 2 7.18773 4.72006 12.7149 7.22552 -5.34662 5.9239 -591 2 8.2239 5.40342 13.6709 -8.7699 -31.8396 -11.1478 -592 1 13.3799 12.1942 14.3144 0.413244 -2.26196 2.0512 -593 2 13.2473 11.2333 14.3131 -4.23433 1.2327 0.0241848 -594 2 13.7366 12.3802 13.4362 1.03232 3.06063 -1.77089 -595 1 14.6196 9.43974 7.2819 12.1284 19.1611 12.5008 -596 2 15.4631 9.9012 7.50833 -13.143 -10.3991 -7.78335 -597 2 13.9498 9.89967 7.80701 0.241302 -5.62146 -3.59828 -598 1 12.6688 16.8855 3.24635 -1.47445 -34.5545 -0.541717 -599 2 12.9124 17.3724 4.01195 4.0393 16.1159 25.6755 -600 2 12.6994 17.4999 2.53895 -2.71389 24.0914 -25.4271 -601 1 1.00064 7.12258 17.3474 25.8989 -13.4919 10.9638 -602 2 0.199171 6.81692 17.7654 -17.9333 6.12878 2.90109 -603 2 0.781412 7.72916 16.646 -4.92956 7.36441 -13.84 -604 1 12.947 4.88013 15.7213 -21.2986 7.3754 -0.931645 -605 2 13.7769 4.45629 15.8524 19.8874 -20.9291 -0.114876 -606 2 13.1805 5.80207 15.7513 2.74699 20.2475 2.05037 -607 1 2.36441 3.38825 5.1495 13.4973 -9.76059 -50.575 -608 2 1.87697 2.96062 5.81278 -27.3053 -18.1487 33.2377 -609 2 2.7907 4.09602 5.58982 16.1263 32.9476 11.4061 -610 1 8.23368 10.9868 13.6471 -16.5646 12.9957 -7.98974 -611 2 8.32411 10.9316 14.5895 -0.490848 -4.77914 16.6738 -612 2 9.07298 10.6867 13.3074 11.7511 -8.07538 -9.61613 -613 1 13.0107 1.52025 13.2616 -13.3177 -0.0328213 18.9383 -614 2 13.4383 1.61013 12.4179 13.267 -2.68379 -13.3373 -615 2 12.5185 2.34771 13.3673 3.11016 -7.04189 -1.75869 -616 1 6.59377 13.5764 2.15874 -7.12741 11.9903 -27.1264 -617 2 6.00679 13.9468 2.8128 -10.8754 6.0075 10.3445 -618 2 7.2163 13.0692 2.66145 9.56033 -10.8956 7.78491 -619 1 15.8548 6.42593 12.5881 24.8624 13.3217 16.2273 -620 2 16.4838 6.96617 12.0488 -16.1868 -9.65605 6.77151 -621 2 16.2214 6.49686 13.512 -7.09801 -2.27572 -23.2114 -622 1 16.7956 0.692247 9.54535 7.46915 17.7641 2.49637 -623 2 16.5452 18.5156 9.96298 -0.0131793 -20.516 -0.238231 -624 2 16.2976 0.789947 8.72228 -2.61192 -2.24486 -4.75056 -625 1 6.11318 11.627 8.27064 9.91462 44.2797 -2.20509 -626 2 5.35292 11.2978 8.70378 -29.3613 -6.33495 17.8965 -627 2 6.52877 10.8496 7.97791 23.4734 -34.8725 -13.0112 -628 1 2.81389 8.67751 0.381383 10.1752 -8.74242 -1.84173 -629 2 2.33278 8.32184 18.2713 -4.10181 -2.8979 1.44899 -630 2 2.25425 9.35695 0.757627 -6.74555 6.18422 5.10447 -631 1 10.1136 10.3815 6.5683 -3.97178 -1.84722 1.40214 -632 2 10.6776 9.73953 7.0164 -1.23094 -3.31757 4.86865 -633 2 10.3499 10.3203 5.64027 4.41826 3.29106 -4.73543 -634 1 6.84727 15.7748 6.6764 -14.7135 -11.7826 9.04786 -635 2 7.02398 16.1904 7.53289 5.38031 2.81892 -3.47781 -636 2 6.91879 16.4549 5.99719 9.07918 3.78678 -4.16926 -637 1 6.52182 12.8956 5.7943 0.541827 3.55761 1.99739 -638 2 6.55778 13.7774 6.19915 3.14226 -1.33255 -2.96851 -639 2 6.13082 12.3068 6.44859 -0.859963 5.03094 3.84811 -640 1 16.7567 12.5314 9.76383 -4.64367 0.23861 8.75508 -641 2 16.9908 11.8798 9.10281 -4.06168 -8.34407 -5.30318 -642 2 17.2898 13.2837 9.5332 2.7418 12.1851 0.697411 -643 1 6.23186 2.86269 2.75104 2.97881 8.48666 -1.38882 -644 2 6.52094 3.78037 2.52233 -11.0321 -17.6889 -1.77294 -645 2 5.63962 2.52843 2.04764 8.59188 6.36028 2.68011 -646 1 10.7835 3.03466 3.2504 -5.97107 -1.61798 -4.71292 -647 2 10.2628 3.82076 3.45136 1.61481 0.158577 0.983482 -648 2 10.306 2.59283 2.52669 4.73542 2.88639 2.9637 -ITEM: TIMESTEP -80 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.82629 6.70343 17.8553 -15.1071 8.15122 13.6853 -2 2 7.99416 6.85162 18.349 10.9787 -1.12299 -6.8679 -3 2 8.57507 6.09547 17.1643 3.5075 -8.11573 -6.04158 -4 1 0.137192 8.33532 6.74353 12.0191 -20.4001 -6.39938 -5 2 0.250097 8.10589 5.79669 -2.0008 6.10915 10.6578 -6 2 0.653601 7.63933 7.2162 -12.3825 18.3147 -3.0068 -7 1 8.60149 0.29664 6.93203 12.1667 -9.17994 12.1946 -8 2 9.52501 0.228788 6.64808 -5.75422 4.1152 -0.42095 -9 2 8.21226 0.977159 6.3883 -5.16274 6.48178 -7.47064 -10 1 6.50463 1.68869 11.7262 -16.2706 -7.92373 -2.85274 -11 2 5.9813 2.3145 12.2428 -2.71472 -2.47934 -1.80386 -12 2 5.86927 0.986784 11.4354 16.7384 10.0214 6.53226 -13 1 6.9131 5.55027 2.37535 3.77295 -5.39511 9.11334 -14 2 6.43692 5.84081 3.17655 -0.921031 3.98795 -14.1822 -15 2 6.69543 6.14979 1.6478 1.12895 -1.48609 4.32855 -16 1 16.196 10.2371 16.1388 -31.5516 2.77844 19.9706 -17 2 16.8915 10.3643 15.5412 37.4 6.14414 -23.2997 -18 2 15.8469 11.1288 16.3108 1.55641 -10.2432 -3.37881 -19 1 10.775 14.9631 2.31622 -5.5944 -0.094079 7.63582 -20 2 10.598 14.4521 3.12767 5.78422 3.02899 -5.84463 -21 2 11.1066 15.8146 2.64245 2.43259 -3.51347 -1.1859 -22 1 17.165 8.21001 10.8825 14.1674 -5.9779 -9.25967 -23 2 16.5809 8.83567 11.3092 -8.03296 12.2385 6.15632 -24 2 17.9797 8.71133 10.6858 -5.20793 -0.650283 -1.86008 -25 1 14.6097 15.9558 16.401 14.8916 -7.54315 9.24646 -26 2 13.6847 16.2494 16.4321 3.25844 -2.02272 0.00765398 -27 2 14.8063 15.4932 17.2527 -13.7355 5.39716 -16.4095 -28 1 12.117 13.3155 0.580411 -1.24587 -0.207976 3.78722 -29 2 11.7909 13.4576 18.3369 0.57388 -2.32058 -15.0609 -30 2 11.6242 13.9531 1.10951 4.78037 0.383607 7.31905 -31 1 9.34228 5.488 3.85121 53.6451 1.51077 14.3512 -32 2 8.91013 5.51861 4.6996 -19.4462 -5.34697 10.1126 -33 2 8.70488 5.4763 3.16894 -36.9473 -0.666442 -22.4182 -34 1 1.61615 3.95559 11.5848 -7.57046 15.5603 -11.9076 -35 2 1.66987 4.89506 11.8258 -4.51216 0.523906 3.16779 -36 2 2.10845 3.4705 12.2371 10.5178 -10.3797 12.993 -37 1 2.10284 6.89743 8.15957 -0.837321 -0.675751 7.8246 -38 2 2.47895 7.28827 8.96165 1.07034 3.30836 -6.30935 -39 2 2.071 5.95646 8.37348 -2.86121 -4.48577 -0.939591 -40 1 5.32433 4.44486 7.86972 -1.34052 23.2477 3.45796 -41 2 5.46877 3.5107 7.98026 -0.0649778 -19.4924 -5.7669 -42 2 4.70188 4.60713 7.1427 0.919422 -2.43856 3.29815 -43 1 3.32435 2.88678 17.4197 -1.88929 -9.6261 16.8991 -44 2 4.05816 3.29734 16.977 14.1471 9.33662 -16.3951 -45 2 2.86083 3.59453 17.8818 -3.32176 6.96255 1.50629 -46 1 7.47308 5.51417 6.17701 6.20604 7.73103 -29.885 -47 2 7.95124 6.07722 6.78768 5.01174 3.41934 10.0258 -48 2 7.09189 4.79949 6.66958 -7.20601 -9.71089 14.7057 -49 1 9.80158 6.99902 12.0223 -22.5784 -4.24274 -21.2019 -50 2 10.1069 6.1805 11.5916 -0.00510546 9.67372 7.70676 -51 2 9.03411 7.28611 11.4542 20.6129 -4.31213 14.2424 -52 1 14.1091 3.78361 8.12438 -15.7573 21.5912 -11.6445 -53 2 13.5201 4.50308 7.77049 18.8532 -19.0333 8.38218 -54 2 14.3457 4.04736 9.022 0.199067 1.13361 3.22772 -55 1 4.50215 17.2152 3.88612 2.87802 -1.37968 10.5361 -56 2 5.34021 17.6676 3.86593 13.8498 1.95887 5.68097 -57 2 3.97594 17.6789 3.24294 -11.45 0.485265 -14.6478 -58 1 16.2741 16.534 10.4726 -5.67102 -12.8311 -21.8814 -59 2 15.486 16.5615 11.0293 -1.33881 1.5325 0.205711 -60 2 15.9943 16.0074 9.67798 5.00326 13.1852 19.554 -61 1 1.98121 4.83276 0.125548 -2.90665 -21.863 0.561723 -62 2 2.62989 5.11603 0.769738 5.61812 10.8419 9.00632 -63 2 1.75087 5.59897 18.2498 0.950825 13.4626 -6.91806 -64 1 11.2654 13.2951 16.4195 -4.34554 -2.68737 -1.67212 -65 2 10.7681 12.4683 16.4833 0.87563 -1.05494 5.85319 -66 2 11.8765 13.1105 15.7039 6.19214 3.55339 -6.25188 -67 1 10.1028 10.9035 16.8331 17.2825 8.49241 1.71185 -68 2 10.5205 10.0327 16.7798 -0.767632 10.3686 4.9905 -69 2 9.17724 10.7556 16.7424 -24.4211 -4.37906 -2.41009 -70 1 11.8507 17.4827 13.4696 7.63981 7.03239 -1.88788 -71 2 12.509 16.94 12.9947 -8.02315 8.08552 1.57387 -72 2 12.1795 18.4053 13.408 -3.08283 -9.25718 -0.840972 -73 1 6.44601 9.4433 12.2773 8.37995 -15.986 -34.1351 -74 2 7.00514 9.1357 11.5138 -12.9725 10.8563 23.5312 -75 2 7.03346 9.94503 12.8365 5.04668 8.97956 7.26084 -76 1 16.2979 12.8575 2.71922 -11.7369 16.949 2.19382 -77 2 17.1652 13.221 2.45954 -10.8006 -1.31331 4.0939 -78 2 15.6758 13.6404 2.78783 18.0783 -23.2667 -2.52892 -79 1 0.707968 12.7192 5.87585 -9.46746 -3.17244 -7.34712 -80 2 1.05314 12.7932 4.98248 12.8843 -1.39545 -4.60697 -81 2 18.4375 12.4692 5.68303 -3.12969 3.97578 10.4064 -82 1 5.29671 16.347 18.4316 -9.43352 6.10902 0.949816 -83 2 5.62099 15.5668 17.9615 5.22561 3.70018 3.69326 -84 2 5.92538 16.5961 0.477291 0.486221 -4.47534 -1.04063 -85 1 0.707184 7.70367 4.119 -51.5024 -35.8612 26.1825 -86 2 0.14378 7.97362 3.40377 -12.5647 4.97441 -12.5535 -87 2 1.50957 8.08535 3.91273 65.7491 26.1316 -14.6887 -88 1 3.20348 9.03456 6.50534 -36.9666 27.611 -24.7826 -89 2 3.63112 8.56754 7.174 27.0077 -25.2244 35.3222 -90 2 2.25579 8.96355 6.72902 9.17057 2.1904 -6.46933 -91 1 7.27937 10.3761 16.2413 -0.230914 -4.48303 6.76598 -92 2 6.52755 10.9587 16.1419 -2.56448 5.11938 -3.06937 -93 2 7.11485 9.96393 17.0986 -0.495486 0.80288 1.59662 -94 1 11.0332 0.910989 5.0177 -6.88619 -3.17881 -8.23488 -95 2 10.972 1.75479 4.54866 7.92386 3.49104 7.17877 -96 2 10.6826 0.325395 4.32946 5.79259 -4.26916 6.55693 -97 1 4.2654 2.89302 13.1773 0.694211 20.6748 -2.64105 -98 2 4.39238 3.45448 13.9576 1.0821 -9.7456 0.782255 -99 2 4.16489 1.98946 13.4871 -0.702651 -10.6992 3.24412 -100 1 8.43419 10.272 1.79599 3.30535 -21.7188 -14.6566 -101 2 8.19585 10.8779 2.48837 0.0509316 11.2873 19.613 -102 2 8.53541 9.39344 2.20281 2.46081 9.96427 2.84146 -103 1 10.2486 1.68186 15.4597 -14.9494 5.38019 -3.47887 -104 2 11.0964 1.37036 15.7536 17.388 -0.916576 -1.92962 -105 2 10.2694 1.89097 14.5087 2.57313 -1.10767 6.05091 -106 1 2.6143 12.7739 7.92246 0.947228 -0.997667 -1.9326 -107 2 3.16975 13.4683 7.54148 -0.729705 2.73148 -0.490338 -108 2 1.96608 12.5591 7.23618 1.36975 0.244975 0.56737 -109 1 3.86268 11.7535 5.00307 -14.4028 -3.16999 8.33757 -110 2 3.70976 11.1475 5.74815 1.12966 3.67823 -8.44516 -111 2 3.06255 11.7297 4.44022 7.7842 4.67892 9.37694 -112 1 6.76061 14.5167 16.9537 -0.888094 -7.58336 -2.84579 -113 2 7.48488 15.1306 17.0914 4.64858 -1.1877 -1.93173 -114 2 6.56705 14.5225 16.0035 -2.02875 6.77169 3.29706 -115 1 14.2034 14.5245 3.20058 -0.0398844 -12.3077 5.38397 -116 2 13.8793 15.4221 3.34301 -5.62621 -2.27359 -1.58508 -117 2 13.7959 13.9448 3.87781 2.42748 11.415 -6.18352 -118 1 8.70505 18.0887 16.0942 -64.5065 -8.09898 -3.91687 -119 2 9.21396 17.4083 16.5058 25.0639 -11.349 2.42178 -120 2 9.16407 0.206988 15.7928 30.835 22.2192 -2.21878 -121 1 4.63692 1.68417 4.88655 37.1566 -9.63698 -3.58798 -122 2 3.87701 2.22405 4.82391 -30.2785 19.7734 3.84799 -123 2 5.28246 2.1077 4.29595 -5.87377 -5.36693 3.35208 -124 1 15.0131 12.6297 16.4887 -20.293 3.22713 36.7225 -125 2 14.5244 12.6173 17.3484 21.3151 5.53737 -15.2497 -126 2 14.2857 12.586 15.869 -0.208138 -0.973548 -24.0506 -127 1 15.729 18.4304 16.8576 -8.95075 23.4819 -17.3869 -128 2 16.2245 18.5231 17.6612 15.7889 -2.20706 14.0604 -129 2 15.4698 17.5226 16.786 -7.06215 -23.0828 1.02158 -130 1 1.394 1.31209 16.6703 -16.8241 -3.16738 2.04331 -131 2 2.15084 1.87826 16.8449 0.715689 -4.34048 -2.49358 -132 2 0.715561 1.66179 17.2756 6.00571 -5.18273 -5.07353 -133 1 18.2252 4.3402 15.9772 -8.55569 -2.73 -13.6324 -134 2 17.823 3.76125 15.3072 5.10239 5.23383 8.49054 -135 2 0.492866 4.4785 15.7127 2.39871 -0.864238 1.29175 -136 1 12.1265 17.032 16.1255 -25.5416 -7.58495 15.967 -137 2 11.3669 16.5924 16.5691 16.6277 5.86514 -1.80192 -138 2 11.8242 17.0598 15.2127 8.00105 4.8532 -10.0676 -139 1 16.1291 2.68344 18.211 0.375456 -13.3929 15.5569 -140 2 15.6138 3.3874 18.6109 -0.098248 15.4546 -4.83257 -141 2 15.8549 2.61026 17.3068 -10.5356 1.78345 -20.9571 -142 1 6.60182 13.7939 10.068 9.2492 3.65708 4.18485 -143 2 6.57275 13.4224 10.9661 -3.78941 -3.14938 -5.19226 -144 2 6.71396 13.0652 9.44214 -7.17216 -3.95227 2.85982 -145 1 10.1302 18.5571 2.70452 28.7428 2.61674 -1.08827 -146 2 10.6588 0.134354 1.90491 -8.77267 0.774664 16.1596 -147 2 9.28539 18.2699 2.40893 -22.5926 -9.32297 -10.0302 -148 1 3.0625 17.7033 6.15366 -32.6923 -3.28618 14.6113 -149 2 2.13754 17.6931 5.7562 38.9757 -0.864197 5.33283 -150 2 3.7049 17.7316 5.44436 -0.964713 0.371031 -13.1926 -151 1 12.6087 16.7853 7.93012 21.3772 -3.32102 -23.3093 -152 2 11.8409 16.2517 7.71322 -11.0279 -6.8961 6.738 -153 2 12.4183 17.3739 8.65053 -14.1479 13.0972 16.1976 -154 1 14.9031 15.2939 8.2802 -30.4011 23.5185 11.3145 -155 2 14.1656 15.9721 8.20757 23.4522 -23.8051 0.0341398 -156 2 15.3634 15.3182 7.4362 3.9964 4.48103 -1.46252 -157 1 17.8706 18.2596 0.245663 2.0948 -17.0514 -11.0411 -158 2 18.6148 17.6985 18.5349 -15.5847 20.6608 16.06 -159 2 18.229 0.448391 0.574358 6.37924 -1.254 -0.87753 -160 1 0.806491 10.487 1.42673 -7.2326 -9.98023 10.4462 -161 2 -0.00161399 9.98055 1.66044 10.6613 4.25192 -4.69396 -162 2 0.557346 11.1929 0.820979 -4.09494 2.43397 -4.83249 -163 1 1.83456 12.2686 3.29043 -8.34448 2.57963 -8.45001 -164 2 1.36787 11.5875 2.7525 13.033 10.6511 2.37549 -165 2 2.15971 12.967 2.6794 -8.27007 -10.3927 7.15994 -166 1 0.688934 17.2807 4.96532 -1.28513 13.5074 -14.6034 -167 2 -0.0176841 17.9487 5.11769 8.40666 -17.1979 3.35047 -168 2 0.596617 16.4414 5.43231 -12.6974 4.79178 9.39957 -169 1 1.09014 0.907525 9.3383 6.29421 1.3921 30.3575 -170 2 1.25758 0.656293 10.2983 -10.9635 5.07818 -25.2558 -171 2 0.281108 0.475301 9.05696 -4.67463 -4.0945 4.23309 -172 1 16.7684 2.39691 13.3495 9.61769 42.5491 2.72371 -173 2 16.904 2.78957 12.4595 -0.731435 -13.0756 10.2936 -174 2 16.527 1.48948 13.2642 -5.98641 -27.7824 -4.48506 -175 1 2.71373 15.9459 12.053 -3.75115 0.267025 20.4445 -176 2 2.98439 15.5717 12.9162 -2.14108 4.62523 -16.3505 -177 2 3.30112 15.6057 11.3695 4.80572 -2.00813 -1.58569 -178 1 16.3912 15.5658 6.1364 -18.5193 -23.7813 -1.39285 -179 2 17.3153 15.4712 6.31079 23.2449 0.130836 8.54259 -180 2 16.3263 16.278 5.5153 -3.20698 17.7917 -15.4301 -181 1 5.73039 5.21537 11.7967 -2.24013 5.33831 8.85226 -182 2 5.58704 6.03693 12.3192 -1.36073 -15.5687 -10.3459 -183 2 5.0707 4.59019 12.1393 4.45693 0.898588 -6.68224 -184 1 15.134 4.90094 0.781902 20.2218 -12.3751 4.08616 -185 2 14.9115 4.68422 1.69179 -1.28767 -2.72314 10.4735 -186 2 14.3889 5.35469 0.437757 -23.5901 14.4279 -10.7703 -187 1 16.3592 16.4594 1.89384 25.1746 19.6936 -18.9686 -188 2 16.2469 16.8 2.79117 -6.86302 3.67352 0.481682 -189 2 16.829 17.1783 1.36994 -16.7874 -21.2348 17.437 -190 1 0.175681 4.85349 3.94905 -38.6563 1.2533 -4.07114 -191 2 0.373462 5.78529 3.89581 11.5619 13.3417 2.94095 -192 2 0.969717 4.36237 4.02266 30.2668 -11.0427 7.4994 -193 1 2.99204 15.0813 15.1763 -0.305205 14.4793 -34.7595 -194 2 2.88713 14.6595 16.0135 -9.94348 -6.29569 26.5741 -195 2 2.4481 15.8945 15.1967 6.07768 -3.34342 6.9782 -196 1 1.12287 14.6661 9.5226 42.1359 23.511 16.8308 -197 2 2.04871 14.8527 9.88052 -40.3465 -4.39318 -17.9218 -198 2 1.08708 13.7187 9.50981 -4.88478 -15.9854 1.2011 -199 1 13.5299 16.5144 11.5405 11.2356 18.9117 4.33104 -200 2 13.1159 17.2557 11.0661 2.81218 -0.6798 2.92705 -201 2 13.1037 15.7572 11.1579 -10.8238 -16.1215 -4.14744 -202 1 4.70977 1.52963 0.718559 3.58248 -24.4192 11.8527 -203 2 4.08939 1.89433 0.0933404 -5.33693 14.3563 -9.66083 -204 2 4.20955 0.796838 1.1277 3.32575 8.01941 1.68952 -205 1 1.50238 18.6141 11.9042 -1.38031 13.5472 16.8753 -206 2 1.45658 0.425239 12.7856 -0.241625 -6.75063 -24.7438 -207 2 2.14944 17.9089 11.9973 -1.06457 -6.06855 3.15913 -208 1 11.4462 10.1354 4.10554 -27.8103 0.519562 13.0103 -209 2 11.5399 10.6236 3.29381 1.04561 4.25273 -17.1067 -210 2 12.3232 9.96387 4.39943 30.3669 -4.33072 3.08727 -211 1 8.16113 12.1728 3.80004 4.97071 -3.14572 14.2587 -212 2 8.9952 12.5305 4.11747 11.4774 1.91239 -11.4095 -213 2 7.64202 12.24 4.61417 -11.8418 -2.63078 -6.07404 -214 1 14.5844 4.03291 3.36716 -4.11232 -3.55002 -24.3582 -215 2 15.2517 4.33672 3.97304 10.7234 0.0718586 14.5399 -216 2 13.7453 4.32617 3.71649 -8.9869 4.72015 4.68372 -217 1 5.72064 1.64489 7.5839 32.9059 28.6425 0.0988457 -218 2 5.06921 1.12259 7.98588 -34.2591 -28.2453 24.4599 -219 2 5.39575 1.74393 6.6993 -3.28926 -2.3453 -25.2911 -220 1 17.8815 1.07824 4.83341 -4.77439 -8.44394 -0.469265 -221 2 18.4195 1.29399 4.06103 3.32925 4.9906 2.38586 -222 2 18.1973 1.60106 5.58304 1.56226 2.04575 -0.708791 -223 1 6.854 9.3046 4.53528 10.3956 -9.62802 3.27507 -224 2 6.69426 9.36632 5.492 2.76918 3.19153 -6.51095 -225 2 7.80605 9.0738 4.45229 -13.5827 1.70924 -0.808399 -226 1 2.59539 14.8276 2.04954 -21.4179 -5.20739 -34.911 -227 2 3.34516 14.7063 2.60932 22.2061 -1.352 15.1427 -228 2 2.90646 14.7931 1.11821 -3.29515 2.22824 22.2692 -229 1 17.3057 12.9587 13.1574 -14.3584 11.8265 -1.68619 -230 2 16.4238 13.3017 13.4505 21.6076 -1.54195 -11.2195 -231 2 17.8123 13.7306 12.814 -13.7958 -9.76612 7.37248 -232 1 14.8715 10.5568 1.52593 -13.8049 33.9422 19.399 -233 2 15.3968 11.3309 1.89043 -12.48 -24.7346 -11.1652 -234 2 13.9264 10.776 1.72699 26.333 -7.21409 -8.066 -235 1 5.65075 6.69227 4.53589 -1.16643 0.470211 -4.08107 -236 2 5.90168 7.60385 4.33311 1.92457 3.57872 5.04239 -237 2 6.31691 6.35225 5.15026 1.24698 1.28263 2.78678 -238 1 8.00933 8.29789 10.2803 -8.03608 2.46456 2.45807 -239 2 8.54459 8.86115 9.67988 -10.051 -7.82575 5.32423 -240 2 7.18397 7.98917 9.84875 17.8376 0.213066 -8.74409 -241 1 13.4452 18.4811 5.71348 30.3006 1.0471 -14.1486 -242 2 12.642 0.299737 5.48582 -19.0854 8.92614 -0.688815 -243 2 13.1967 17.7426 6.25238 -10.7462 -10.7439 19.4962 -244 1 -0.0119027 2.59488 0.354931 35.8038 -39.8932 13.3955 -245 2 17.7273 2.51611 0.10594 -24.5443 11.4005 -8.19311 -246 2 0.27212 3.48779 0.285479 3.99253 30.2779 -6.4317 -247 1 12.849 10.869 9.75158 -6.21929 20.5855 -7.88953 -248 2 11.8713 10.9784 9.78619 15.6811 -13.8069 -0.457669 -249 2 13.0615 9.92753 9.83861 -13.7986 2.36182 2.76964 -250 1 0.623186 12.214 11.083 4.78072 12.4497 9.66308 -251 2 18.3291 12.2937 11.2784 -7.07035 -2.86266 -6.1852 -252 2 1.03568 12.566 11.8864 5.16139 -3.44089 -5.05626 -253 1 5.24317 7.35288 13.329 16.5645 10.6427 9.86574 -254 2 5.81232 8.06371 12.9598 -16.2044 -6.02954 3.80806 -255 2 5.63373 7.21351 14.2126 -3.74153 -4.80134 -10.81 -256 1 1.17457 6.8033 11.9036 -23.8679 10.4664 -9.71638 -257 2 0.289623 7.06715 11.5324 26.398 -8.64759 11.7652 -258 2 1.56564 7.61974 12.2537 0.753648 -2.9175 -1.70229 -259 1 15.4919 9.76734 12.3795 0.0614124 -7.36309 3.05776 -260 2 15.0846 10.6319 12.2391 7.36463 -2.83561 -3.47144 -261 2 15.8873 9.82027 13.2467 -0.105969 -0.524429 6.2821 -262 1 16.5022 12.5635 5.51418 5.92626 -4.93161 -13.1981 -263 2 16.3002 13.4761 5.69188 -2.75562 16.3616 9.80459 -264 2 16.3759 12.5305 4.55079 1.66896 -8.7704 1.12914 -265 1 6.31756 9.85145 0.122373 -12.0354 8.37982 6.54531 -266 2 5.4699 10.2439 0.423151 12.3884 -4.45977 -3.2374 -267 2 6.98984 10.1338 0.758446 2.49067 2.04662 0.271789 -268 1 12.1918 6.08954 4.01066 -16.388 -25.9861 2.6766 -269 2 12.1912 6.72626 3.29268 0.559249 7.6643 3.09763 -270 2 11.3251 5.63233 3.94387 14.2823 13.1494 2.08097 -271 1 0.332379 12.8663 0.0441745 0.0508304 2.00456 8.93046 -272 2 18.9019 13.5185 0.756349 -7.27218 -2.99587 0.981784 -273 2 18.3327 13.1573 18.0278 2.80865 -1.79272 -4.8195 -274 1 3.54313 0.0443203 8.66238 11.9606 -6.13667 -3.48184 -275 2 3.32458 18.1774 7.87344 8.237 1.02812 -5.83338 -276 2 2.68777 0.391851 8.89446 -8.31408 9.03305 4.42594 -277 1 7.44404 17.5122 4.49167 0.119683 3.6114 3.91179 -278 2 7.85567 18.3869 4.65486 -14.0238 -13.6963 -7.23825 -279 2 7.39901 17.3877 3.53399 5.58618 2.96743 1.37553 -280 1 9.26713 17.153 12.2094 -20.2295 17.8608 7.81194 -281 2 9.28392 16.3133 11.7674 1.3049 -15.888 -12.5165 -282 2 10.076 17.208 12.7094 15.0452 0.291548 7.10451 -283 1 13.4068 13.0832 7.92217 -6.10698 -2.73533 15.5952 -284 2 13.4694 12.4257 8.66119 -0.459118 13.24 -15.7611 -285 2 13.8946 13.8972 8.17425 4.86633 -17.7849 -1.17812 -286 1 14.7977 2.95386 15.4326 21.7471 11.1646 11.1554 -287 2 14.1505 2.32893 15.1446 -13.9872 -17.9607 -8.38755 -288 2 15.4352 3.02911 14.7173 3.23846 -4.77681 -7.04868 -289 1 9.91022 15.6467 16.9338 -7.88269 11.4297 -3.43074 -290 2 10.0979 14.7902 16.532 6.40878 -6.10819 3.84543 -291 2 9.43747 15.4751 17.7557 1.6004 -7.26983 6.6271 -292 1 11.2148 8.51865 16.6243 -9.14606 -19.2231 -14.9185 -293 2 10.4285 8.06123 16.2547 13.8022 0.848227 5.21642 -294 2 11.6642 7.88268 17.1928 -1.33785 -0.880144 3.29074 -295 1 3.96477 18.2022 16.8388 0.151724 27.8243 14.0652 -296 2 4.47646 17.6367 17.4198 3.54357 -14.0579 0.0762873 -297 2 4.08749 0.446059 17.2373 -6.51294 -16.617 -15.0442 -298 1 2.23636 4.23466 8.90617 11.6474 4.96614 0.176633 -299 2 3.18727 4.06881 8.84702 -5.0902 0.586039 -2.82984 -300 2 2.03755 4.18072 9.84669 -2.61694 -5.47133 1.10155 -301 1 9.89683 10.3797 9.78633 12.6385 -21.4053 -24.2531 -302 2 9.49137 11.1552 9.42946 -10.1833 20.5571 -3.63947 -303 2 9.86232 10.3926 10.7266 0.554165 3.61624 28.8421 -304 1 9.72109 0.91625 10.832 13.6195 9.02414 1.59857 -305 2 9.21789 0.206273 11.2536 -3.38139 -4.49977 -6.76529 -306 2 9.17946 1.37162 10.1615 -3.40595 -8.11879 6.74876 -307 1 9.15707 15.1255 10.1914 20.6551 -3.22149 9.33909 -308 2 9.01609 15.916 9.68312 -8.41387 13.877 -8.61246 -309 2 8.34011 14.6408 10.1195 -14.233 -7.19689 -0.719266 -310 1 0.808146 9.70808 10.2086 23.84 -38.9856 -20.0319 -311 2 0.930598 10.6496 10.3444 5.65872 6.03362 4.8682 -312 2 1.64643 9.29884 9.83207 -32.5144 23.6532 16.8406 -313 1 17.0698 4.80337 8.05752 27.8638 -35.1931 -3.66362 -314 2 16.2966 5.30586 8.21629 -27.2809 18.9512 9.97555 -315 2 16.9993 3.9693 8.55928 -0.62818 15.8913 -5.61459 -316 1 14.8223 14.6574 0.153467 -11.4546 -14.4551 -9.90243 -317 2 15.436 15.0274 0.766448 14.8773 15.1477 17.5942 -318 2 14.121 14.2916 0.705806 -3.92817 0.026116 -2.07816 -319 1 3.85634 11.0156 9.57857 3.75671 2.20251 0.903354 -320 2 3.89754 11.3203 10.4983 -5.37308 2.01291 2.42961 -321 2 3.35837 11.6719 9.06911 -6.8083 1.73507 0.204751 -322 1 11.3728 10.7464 1.42992 33.2497 -4.81825 9.44885 -323 2 11.5281 11.6383 1.10055 0.915848 5.55374 -4.33141 -324 2 10.4426 10.6155 1.47257 -31.1398 -0.627116 -5.41705 -325 1 13.1828 7.20447 12.6676 -0.0478479 -14.2604 -0.4669 -326 2 14.1298 6.99811 12.5505 -7.76827 -0.67018 4.43892 -327 2 12.735 6.32848 12.7534 7.45412 15.7346 -2.47341 -328 1 9.63194 1.91441 0.890304 3.16134 4.31897 -8.70512 -329 2 8.77158 1.63222 0.526893 10.8452 7.48256 0.350857 -330 2 10.2032 2.19638 0.151243 -8.90992 -2.48069 6.74103 -331 1 10.6318 13.4626 4.55882 -11.5056 -1.99047 12.5083 -332 2 11.4876 13.0509 4.71851 7.47615 -1.29416 -2.63952 -333 2 10.4232 13.8662 5.41293 0.691023 4.41994 -1.81408 -334 1 14.5517 1.66181 10.9802 -11.5576 12.9 9.45395 -335 2 15.3776 1.3055 10.6442 8.04202 2.4344 -3.19562 -336 2 14.6907 2.6148 11.169 4.38713 -8.31284 -15.1855 -337 1 14.4901 12.0498 11.5809 -31.454 -4.77499 25.6083 -338 2 15.091 12.4736 11.0015 28.7023 12.1919 -21.8177 -339 2 13.8321 11.6274 11.0162 -1.74489 3.16984 -4.97875 -340 1 8.17369 5.13537 9.87952 -12.8505 7.96449 12.3464 -341 2 7.30162 5.126 10.3345 14.626 0.500686 -8.94194 -342 2 8.32701 4.24033 9.57061 -3.03583 -8.79147 -1.32617 -343 1 1.61182 16.9829 18.4557 19.3906 15.8485 -25.2691 -344 2 2.09739 17.4464 17.7224 -9.17701 -12.9822 18.3353 -345 2 1.80792 16.0477 18.3234 -0.14796 -4.92565 -1.79656 -346 1 1.43858 17.3769 15.3174 -8.9259 8.94647 7.52005 -347 2 1.45812 18.1702 15.9147 -6.93156 -15.9408 -17.1792 -348 2 0.507347 17.0882 15.1685 14.4449 8.30676 8.33907 -349 1 3.5257 5.78471 6.06613 -3.39677 -13.3058 1.89016 -350 2 2.9753 6.46227 6.46115 -3.38454 1.41808 7.55669 -351 2 4.15739 6.26663 5.53865 9.2569 4.30143 -12.1591 -352 1 12.629 9.51298 14.2604 -9.77978 19.3775 3.35531 -353 2 12.9437 8.76225 13.7938 15.2815 -22.6591 -22.819 -354 2 12.3447 9.10922 15.0729 -6.56341 1.36458 18.6396 -355 1 4.0928 15.2431 7.0497 -2.25109 -22.7738 13.7055 -356 2 3.66448 16.0653 6.81785 -2.80743 13.3283 -7.68 -357 2 5.04695 15.3859 7.01583 3.36741 6.66555 -6.63338 -358 1 0.780201 8.79903 15.0924 -4.1065 -28.223 6.26572 -359 2 0.548696 9.72105 15.1288 -1.34907 18.7642 -4.10325 -360 2 1.5752 8.72345 14.5481 -0.207921 7.22304 -3.82448 -361 1 12.9286 8.29499 10.1476 33.3114 -28.911 32.5654 -362 2 13.7554 7.80683 9.90421 -18.1809 10.2081 -7.43875 -363 2 12.9042 8.10572 11.1188 -9.83308 4.93442 -19.3471 -364 1 15.2998 7.93844 3.50826 -21.0939 -7.00262 -11.8412 -365 2 14.4558 7.58878 3.24395 -11.6977 10.4201 -28.099 -366 2 15.3831 7.3862 4.26257 30.2163 -1.92794 33.2483 -367 1 17.18 6.71526 18.6425 -0.133844 12.8911 -12.7702 -368 2 16.7451 5.93694 0.322596 -6.25651 -15.7248 7.28694 -369 2 16.4413 7.25778 18.3094 9.30548 1.37884 5.01187 -370 1 8.9084 6.99396 7.88573 -0.881002 2.32267 0.0260346 -371 2 9.83584 7.2627 7.79742 -0.0847644 -0.13812 3.11438 -372 2 8.83558 6.46246 8.69404 -0.0294368 0.694249 -1.22754 -373 1 12.437 0.501834 1.22358 -0.716997 -8.58934 -9.29719 -374 2 13.1312 1.05983 1.5788 8.89791 0.478791 5.50433 -375 2 12.732 0.307907 0.326573 -3.73597 1.67796 1.81541 -376 1 5.69458 15.0516 14.5143 3.69591 -14.2553 -4.53333 -377 2 4.76954 15.0969 14.776 -8.31751 1.66253 0.63197 -378 2 5.95328 15.9515 14.3109 5.80865 11.3045 -3.56535 -379 1 3.78081 6.42509 1.75203 4.2348 -8.30075 -4.29513 -380 2 3.33672 7.18396 1.37288 -3.60544 13.0853 -6.67388 -381 2 3.84967 6.63422 2.68491 0.545892 0.795555 6.86444 -382 1 3.88792 11.3989 12.3546 13.0971 -5.24635 -8.64578 -383 2 4.74838 11.8202 12.5261 -6.66532 -1.91753 0.168546 -384 2 3.23677 11.927 12.8169 -5.64663 9.70313 4.55872 -385 1 5.30252 3.85246 15.7701 3.45242 11.6571 4.53522 -386 2 6.06202 3.27771 15.61 2.30678 -4.65184 -5.35711 -387 2 5.68598 4.72788 15.9368 -2.89319 -4.23448 -3.12102 -388 1 14.1378 10.1309 4.62741 -6.40911 2.93718 -21.1253 -389 2 14.285 9.82325 5.50803 7.98673 -9.05047 24.7099 -390 2 14.6717 9.53242 4.07811 -2.84302 6.29722 1.17771 -391 1 7.65634 17.3346 9.10408 10.3132 -24.7491 -1.74792 -392 2 7.07794 17.6856 9.78277 -9.16436 8.21537 0.604828 -393 2 7.96278 18.0151 8.50473 -0.553145 15.1908 -4.94918 -394 1 4.52232 14.5173 3.95827 12.1345 -25.6108 -47.7046 -395 2 4.42958 15.3956 4.25649 -1.76895 36.8878 18.7873 -396 2 4.4098 13.9051 4.66351 -3.8607 -15.3504 25.5968 -397 1 14.1258 7.45828 15.8364 -6.23365 -6.73609 3.75314 -398 2 14.9302 7.39167 15.3277 7.57838 -0.290505 -5.08612 -399 2 14.4287 7.78058 16.69 -2.09073 5.34234 4.78248 -400 1 2.95098 18.3751 1.91859 -29.5535 -1.78839 -16.8987 -401 2 2.45071 17.8858 1.20736 17.1758 4.42604 21.0133 -402 2 2.2449 0.246547 2.36374 11.8246 -5.6794 -7.15496 -403 1 7.99154 1.5773 4.49846 30.6245 -5.45524 3.73918 -404 2 7.42382 1.97686 3.83614 -1.09908 5.00667 -8.45405 -405 2 8.90683 1.55308 4.13454 -22.7919 6.21994 3.05753 -406 1 2.44336 14.1732 17.7263 2.89693 8.8065 2.99283 -407 2 1.80182 13.5359 18.0713 -0.462046 0.279758 -5.24045 -408 2 3.30188 13.814 17.96 10.6791 -8.66055 4.12847 -409 1 0.94217 1.90899 13.8934 13.5408 -1.52741 -1.05885 -410 2 1.19747 1.57322 14.7589 -4.95142 3.16298 5.50662 -411 2 18.6373 2.03702 13.8998 -8.7871 -0.483879 -2.02084 -412 1 4.30938 0.151078 13.8855 7.43827 7.09651 -9.2822 -413 2 5.23906 18.5299 13.9426 -3.76642 -3.92995 -1.86801 -414 2 3.88869 18.4591 14.673 -3.49259 -4.03929 12.0029 -415 1 7.32054 0.93366 18.4163 -33.3446 -10.4004 5.92831 -416 2 7.32153 0.654144 17.4916 5.03052 -1.00997 0.0977128 -417 2 6.36163 0.937686 18.6972 26.0729 9.45288 -6.86634 -418 1 15.8933 18.4156 13.9169 -22.9956 8.12347 -47.8741 -419 2 14.9583 18.5802 13.6337 24.0447 -6.26997 16.1472 -420 2 15.9487 18.2637 14.8423 -3.56821 2.97357 29.888 -421 1 10.2651 4.57121 16.2688 1.93413 -35.0494 -13.7078 -422 2 11.2092 4.46181 16.4883 -7.31309 8.12251 -3.69007 -423 2 10.0229 3.6678 15.9192 2.49448 27.3645 14.4368 -424 1 15.9059 17.707 4.46041 -10.2591 -26.7612 -3.24664 -425 2 16.489 18.4443 4.44561 19.3223 26.1038 4.21423 -426 2 15.1093 18.0276 4.88994 -9.23113 3.77657 -1.20249 -427 1 6.91304 17.5561 13.9404 -32.5423 1.81832 8.8205 -428 2 7.45718 17.7359 14.6891 13.6263 3.56972 27.349 -429 2 7.55119 17.4736 13.2627 22.9256 -5.60471 -32.7019 -430 1 13.1887 6.46821 6.52506 2.14134 -6.99498 -16.9539 -431 2 14.1468 6.55272 6.36688 -10.1834 4.86047 2.66897 -432 2 12.7776 6.33144 5.63446 11.1073 4.86992 20.3892 -433 1 7.86929 2.3014 9.43186 -7.43999 -0.581733 -7.42672 -434 2 7.28758 2.26368 10.206 1.54253 -4.13193 1.23421 -435 2 7.37428 1.85692 8.71867 3.17855 7.90221 2.8646 -436 1 15.2039 14.7441 13.779 -1.62406 2.57688 -1.70285 -437 2 14.9354 14.9492 14.6806 -4.8726 3.09257 3.44485 -438 2 14.7582 15.3762 13.1995 0.661267 -3.02741 1.58802 -439 1 9.4149 8.38535 3.859 -25.1665 -10.991 -5.57318 -440 2 10.2049 8.88585 3.99067 20.2759 12.8236 2.22258 -441 2 9.67249 7.46496 3.96553 -1.56288 -2.67339 -2.00262 -442 1 17.7026 13.5834 16.4242 -1.80346 -11.0476 6.4727 -443 2 16.7549 13.3713 16.3986 -0.662501 7.25922 -2.44544 -444 2 17.8485 14.4294 15.9813 -4.13054 1.45271 -4.35383 -445 1 4.91191 10.5224 2.88074 35.1139 -21.7488 -13.7776 -446 2 5.74832 10.1175 3.20879 -18.1595 7.39309 -6.65206 -447 2 4.64711 11.0636 3.60968 -4.98951 12.9254 11.8317 -448 1 3.70989 8.40692 9.9178 -3.43098 -13.3807 16.77 -449 2 3.72102 9.34916 9.72654 3.49477 5.64054 -2.09668 -450 2 3.74613 8.34545 10.8924 -2.49133 1.09455 -12.0955 -451 1 15.9811 6.93645 5.90716 -9.64967 -5.56515 0.983492 -452 2 16.7246 7.40088 6.29715 7.31355 3.31596 3.21676 -453 2 16.2311 6.00551 5.84179 2.78737 3.87161 -3.53071 -454 1 15.2416 7.2288 8.97537 -25.1477 -13.3308 -14.4253 -455 2 15.9965 7.60799 9.37505 30.1105 10.4166 22.3283 -456 2 15.0439 7.80906 8.23828 -3.19363 1.15625 -6.55237 -457 1 6.20437 12.8345 12.7354 -14.1465 10.1654 -16.7884 -458 2 6.94522 12.3758 13.1101 18.4885 -10.5564 10.7987 -459 2 6.04629 13.6348 13.2503 2.66058 2.52169 8.79246 -460 1 12.1262 4.55048 13.1243 17.0811 13.049 12.1055 -461 2 12.3395 4.65477 14.0809 -9.37635 -6.07885 -14.152 -462 2 11.329 4.03313 13.0256 -8.31182 -5.5816 3.57791 -463 1 11.4354 8.07801 7.94226 -0.810806 3.70784 -8.7596 -464 2 12.2037 7.66847 7.47953 -11.1819 -0.00285319 12.9065 -465 2 11.6202 8.13058 8.89801 9.03316 -1.52538 -12.7532 -466 1 16.9943 10.8342 7.6109 -5.03955 -8.49642 17.9987 -467 2 17.7716 10.3123 7.42961 10.8043 -13.0503 -0.479497 -468 2 16.9113 11.4133 6.86596 -8.14606 13.8231 -19.3584 -469 1 5.21042 18.0585 10.7699 15.6232 7.92267 2.97831 -470 2 4.74775 17.5474 11.4283 -5.6196 -5.04348 5.46467 -471 2 4.57391 18.2408 10.077 -8.01525 -1.2934 -10.8517 -472 1 7.60043 17.4332 1.64042 6.79415 6.05281 -21.827 -473 2 7.93761 16.6332 1.20425 2.91062 0.230192 8.27204 -474 2 7.75711 18.1408 0.980897 -9.32049 -5.6032 10.0359 -475 1 1.93897 12.9382 13.63 3.13689 -3.11692 -16.6768 -476 2 1.43678 12.3217 14.1546 -10.1951 -7.38374 9.42459 -477 2 2.04891 13.7234 14.1672 6.66588 6.79896 5.37665 -478 1 9.3938 6.77683 14.8244 15.3217 -3.43003 -1.39025 -479 2 9.8639 6.00007 15.2423 -8.39432 15.0581 -15.9266 -480 2 9.75443 6.97816 13.9251 -4.83499 -14.7492 16.6004 -481 1 15.2802 4.37234 10.7612 17.1837 -0.598437 7.1821 -482 2 16.2442 4.23454 10.6079 -20.4209 -0.451849 5.19081 -483 2 15.2528 4.98337 11.5249 -0.66536 -5.42981 -12.7574 -484 1 11.4105 6.21551 0.0734026 -8.7314 7.93342 -2.27424 -485 2 11.3895 5.26963 0.0141504 12.2817 -18.3718 -0.889513 -486 2 10.499 6.41528 18.4856 -6.56297 9.87049 -0.998012 -487 1 18.513 11.4235 14.9225 12.9282 -22.681 3.72438 -488 2 17.9895 11.7369 14.1972 -5.90482 9.25399 -19.4183 -489 2 18.3571 12.0937 15.574 -0.537982 14.5307 17.0247 -490 1 7.08328 9.28085 7.30918 -19.7197 4.18214 5.56511 -491 2 6.73297 8.51044 7.78417 1.76821 -0.286333 -7.5509 -492 2 8.01676 9.1548 7.24802 24.3996 -5.081 -1.83944 -493 1 18.3255 15.3437 12.2137 -3.8694 0.735905 0.400418 -494 2 0.599616 15.5 11.9645 6.26195 2.32841 -0.363056 -495 2 17.7995 15.7522 11.5099 -2.40985 0.96637 0.371307 -496 1 16.511 4.37404 5.22763 -21.2214 -5.51878 25.3236 -497 2 16.4647 3.99489 6.12381 2.74309 1.28503 -9.80457 -498 2 17.4303 4.54035 5.0616 22.4703 -0.915278 -13.9933 -499 1 17.7218 3.13981 10.7749 -4.33552 13.9915 6.34554 -500 2 18.6231 3.34836 11.0663 1.21144 -2.68719 -3.11144 -501 2 17.734 2.28626 10.3485 2.99182 -14.4528 -5.38806 -502 1 12.2792 18.655 10.1327 17.2693 -45.8263 -15.1364 -503 2 11.5058 0.449575 10.4425 -26.2107 18.2097 8.79889 -504 2 13.0094 0.611642 10.1232 12.3896 24.8189 4.81349 -505 1 10.4214 9.73086 12.5154 -11.4047 -1.1898 4.78042 -506 2 11.1516 9.87418 13.1364 2.96428 -4.00819 -1.03044 -507 2 10.2474 8.77319 12.4992 9.30457 6.64045 -3.3636 -508 1 0.651598 2.68478 7.18172 -17.9134 21.5061 -11.8097 -509 2 0.347525 3.6016 7.34273 5.69642 -14.867 -2.54197 -510 2 0.849668 2.34638 8.05251 8.91351 -8.30419 8.52406 -511 1 0.318497 15.272 6.90444 -3.43175 -0.902574 -18.2314 -512 2 0.478582 15.5644 7.78858 6.40513 2.68345 23.4663 -513 2 0.623162 14.3599 6.89897 0.272636 -4.92753 -7.69196 -514 1 17.0533 6.94572 15.0273 7.81631 0.565766 -0.894277 -515 2 17.8128 7.55845 14.958 -6.36521 -5.11302 -0.197876 -516 2 17.4132 6.11744 15.3876 -1.58799 4.21551 0.905627 -517 1 9.15046 12.5368 8.00027 -36.358 14.0028 8.44058 -518 2 9.59383 11.9142 7.43445 3.21629 -19.4527 -15.2125 -519 2 8.22229 12.648 7.66907 25.8785 -7.47424 5.38289 -520 1 1.16102 1.67919 2.79298 -14.264 -19.5534 -4.4961 -521 2 1.06769 2.21394 1.99483 -1.93616 3.76767 1.09072 -522 2 1.84572 2.00753 3.35812 13.0572 19.5695 8.60311 -523 1 4.13351 15.1441 9.8761 6.18483 -5.86151 -6.61306 -524 2 3.91524 15.1965 8.93344 2.62784 3.42174 0.908977 -525 2 5.03514 14.7702 9.87632 -7.63961 1.62567 3.94135 -526 1 7.3909 2.2738 14.7748 9.28558 9.05007 -9.33433 -527 2 7.12441 1.5503 14.2057 -1.53405 -3.63662 -1.19206 -528 2 7.87829 2.88836 14.1809 -18.0097 -8.54319 17.0088 -529 1 18.3492 14.5565 2.15246 12.0934 24.362 7.12212 -530 2 0.551729 14.8667 2.53499 -6.69921 -6.84856 -6.85574 -531 2 17.7888 15.364 2.12839 1.3753 -15.6354 -3.85708 -532 1 10.0163 2.6808 12.9164 -0.493731 -5.11601 -9.40492 -533 2 9.92018 2.0572 12.1601 0.76191 10.4011 8.73608 -534 2 9.26265 3.29452 12.869 4.65507 -2.10266 -3.09911 -535 1 2.95427 8.9021 13.1034 24.5728 -3.04867 -5.91166 -536 2 3.51177 9.68096 12.817 -20.8286 -16.9148 9.19061 -537 2 3.59809 8.18481 13.2917 -7.73525 14.463 -2.49767 -538 1 3.26448 8.6069 3.78485 -10.2248 -21.121 34.5648 -539 2 3.76672 9.19042 3.24166 13.0731 20.305 -12.8555 -540 2 3.48359 8.83627 4.72374 -5.93153 -5.30867 -25.3462 -541 1 5.8473 7.24819 8.6208 2.3932 7.90906 9.86277 -542 2 5.81432 6.28497 8.53212 -5.5277 -2.57364 -0.635967 -543 2 5.0659 7.54439 9.12071 1.08185 -7.49096 -4.29671 -544 1 14.8764 1.57981 1.83846 12.2497 10.4795 -14.7641 -545 2 15.1104 2.2908 2.43504 -9.02026 1.90223 13.0204 -546 2 15.3525 1.8445 1.03212 -8.04537 -15.132 5.23431 -547 1 8.61698 15.0264 0.696156 7.89205 -2.64916 2.43147 -548 2 9.41092 14.8348 1.25307 -18.4618 8.30064 -5.38467 -549 2 7.89576 14.464 1.0316 3.03152 0.23278 2.41128 -550 1 15.4513 1.4301 7.20503 6.99627 -6.82188 0.69389 -551 2 14.8244 0.90582 6.69357 -2.8394 0.789398 0.0418873 -552 2 15.0149 2.26607 7.38205 -7.95005 6.31947 4.24803 -553 1 4.96675 12.927 18.445 -0.392058 -1.0762 11.0005 -554 2 5.34886 12.9244 0.695922 -4.30965 1.19363 -4.30526 -555 2 5.68 13.266 17.9034 2.74534 3.65082 -4.88489 -556 1 15.3953 8.66034 18.0902 -2.07624 -16.7815 -3.18775 -557 2 15.9144 9.19311 17.4724 -5.66293 4.97787 2.21077 -558 2 15.1583 9.22886 0.188985 2.48846 7.45062 3.31632 -559 1 12.0359 3.11648 18.28 -8.04977 7.84102 -5.19135 -560 2 12.2901 3.11968 0.565205 5.43673 -10.4163 -2.44039 -561 2 12.4787 2.41139 17.7764 2.20222 0.638625 8.9068 -562 1 13.1884 12.6911 5.14611 -2.25763 -6.31837 -0.123489 -563 2 13.4652 11.7849 4.90596 3.78769 10.9202 3.38983 -564 2 13.3386 12.7839 6.10454 1.74722 -2.69816 -5.37077 -565 1 6.12211 7.19464 0.152335 -0.889801 -16.5081 12.3486 -566 2 6.2475 8.12337 19.0248 -9.08967 1.02729 -5.81202 -567 2 5.35557 6.85974 0.666933 3.80599 9.00251 -10.0268 -568 1 17.6814 15.8746 14.896 -32.95 0.345881 -9.96463 -569 2 16.7135 15.9334 14.9982 15.4899 6.1636 11.5551 -570 2 17.7111 15.6936 13.9484 19.9419 -0.275145 -3.25111 -571 1 13.1284 0.88699 16.7751 -4.95458 6.20661 5.10718 -572 2 14.0638 0.660956 16.7688 7.30918 -0.228866 0.981928 -573 2 12.6898 18.6827 16.6682 -2.70263 -7.7996 -4.366 -574 1 10.8711 14.4993 7.46323 15.7126 -17.3597 -1.2585 -575 2 10.128 14.0173 7.85917 4.58757 6.56369 -3.56814 -576 2 11.6082 13.8461 7.48059 -10.4237 16.2655 0.791757 -577 1 17.6751 8.40087 2.13849 -13.7675 10.6042 3.42109 -578 2 16.7708 8.37025 2.51335 11.2555 0.423493 -3.0905 -579 2 17.6147 7.881 1.33167 1.95975 -7.58305 -2.5048 -580 1 12.424 7.82566 2.03348 6.80204 18.2298 -3.36389 -581 2 12.2928 8.74872 1.74157 -3.31877 -9.32949 5.70746 -582 2 11.9673 7.27395 1.39444 0.405274 -3.29714 -11.9602 -583 1 12.0088 14.6056 10.3972 49.4943 -15.6831 -19.0447 -584 2 12.4654 14.316 9.56616 -19.1829 7.51475 23.0356 -585 2 11.0956 14.6861 10.1978 -35.275 4.57666 -6.07844 -586 1 6.81054 6.90501 15.534 -24.6279 -1.31201 9.93627 -587 2 7.70831 7.14913 15.3109 11.0416 1.99651 0.427612 -588 2 6.48555 7.50951 16.2192 7.91049 -4.43387 -1.91407 -589 1 7.94039 4.47545 13.2332 14.4982 34.8647 21.806 -590 2 7.26408 4.6474 12.5684 -6.44209 3.92223 0.968251 -591 2 8.05746 5.34482 13.7439 -3.25809 -36.365 -21.9094 -592 1 13.3499 12.2014 14.3127 -1.24116 1.37617 13.1465 -593 2 13.3241 11.2332 14.3368 -6.04942 0.470969 -4.28371 -594 2 13.6308 12.4336 13.4212 3.90264 0.498209 -3.09495 -595 1 14.5954 9.45997 7.28998 13.2192 -1.86441 -1.0042 -596 2 15.4197 9.90762 7.5754 -11.2574 0.0534663 -4.99205 -597 2 13.8535 9.8793 7.72336 -3.17401 5.05716 8.17378 -598 1 12.6619 16.8656 3.26711 -0.0867316 -13.7478 -1.21165 -599 2 12.9036 17.3981 4.01825 1.80146 10.547 8.89773 -600 2 12.7645 17.4143 2.493 -0.0316456 12.4477 -7.66427 -601 1 1.00141 7.10091 17.3455 15.3286 -2.27437 -0.63111 -602 2 0.197357 6.73674 17.6796 -23.7065 -4.2556 16.6559 -603 2 0.696205 7.72166 16.6912 7.12828 11.4292 -16.7267 -604 1 12.984 4.84784 15.752 -30.1278 -7.6986 -1.85236 -605 2 13.773 4.32613 15.627 12.1969 -0.534485 4.03194 -606 2 13.2127 5.76882 15.785 16.3015 19.3583 1.60965 -607 1 2.35806 3.40155 5.13736 7.00458 -19.3644 -43.6846 -608 2 1.86996 2.9687 5.81855 -13.4119 -5.52905 24.958 -609 2 2.73401 4.18924 5.49805 8.9837 23.3098 13.0491 -610 1 8.19273 10.9521 13.6844 -8.81681 4.64201 23.2716 -611 2 8.19092 10.7627 14.6526 -0.424045 0.881441 -21.4162 -612 2 8.95149 10.4932 13.3231 15.2004 -1.23984 -4.72202 -613 1 13.0449 1.52469 13.2577 -17.2068 8.30684 11.3152 -614 2 13.5293 1.59874 12.4201 -3.55841 -0.219514 3.90721 -615 2 12.4208 2.28784 13.3343 18.9425 -17.4385 -9.09999 -616 1 6.61166 13.6023 2.12464 -9.14589 11.0627 -26.7302 -617 2 6.03511 14.0379 2.75872 -4.67031 1.02227 7.02539 -618 2 7.1693 13.0213 2.62577 8.97168 -8.12604 14.3361 -619 1 15.8326 6.37868 12.5447 13.0084 18.5244 20.7727 -620 2 16.3675 6.96965 11.9727 -5.6566 -10.5049 5.53461 -621 2 16.1589 6.56267 13.4684 -3.25982 -7.33208 -24.589 -622 1 16.7829 0.679169 9.53725 3.65315 -1.00951 10.2573 -623 2 16.653 18.4141 9.83094 1.34292 -7.75704 2.15353 -624 2 16.269 0.772043 8.73148 -3.87084 4.41009 -12.8197 -625 1 6.12871 11.643 8.2509 28.8456 37.0564 -10.7514 -626 2 5.32101 11.4251 8.67159 -25.2961 -16.2243 16.4685 -627 2 6.59615 10.8374 8.068 1.48557 -20.4229 -4.39625 -628 1 2.81588 8.6455 0.385911 -12.1168 -14.4708 -15.8933 -629 2 2.2408 8.27575 18.315 12.5525 5.70225 18.3425 -630 2 2.25296 9.2478 0.88122 -2.81952 5.7616 1.15354 -631 1 10.1112 10.3249 6.56463 -6.88185 10.2676 4.3595 -632 2 10.6724 9.72741 7.0699 2.3169 -7.24343 0.885556 -633 2 10.4905 10.3984 5.68005 1.7842 -2.70629 0.197339 -634 1 6.85117 15.7741 6.71172 -4.51814 -4.38518 8.0947 -635 2 7.10947 16.276 7.50071 -0.280141 -2.70051 -1.05147 -636 2 7.0022 16.3747 5.97143 2.95927 2.8361 -5.64101 -637 1 6.55245 12.8624 5.85582 3.66478 4.31955 2.99752 -638 2 6.71899 13.7301 6.24424 -0.933807 5.79026 -3.46681 -639 2 6.12481 12.3549 6.55179 0.263982 -0.200358 2.15574 -640 1 16.7435 12.5401 9.7846 -13.9618 -8.21713 16.7649 -641 2 16.8388 11.8663 9.10427 2.99064 0.578166 -4.74348 -642 2 17.1608 13.3339 9.48085 7.01955 11.3182 -8.14386 -643 1 6.27773 2.82725 2.7475 -16.1332 4.52919 -16.5002 -644 2 6.37029 3.76301 2.48637 6.52487 -6.75351 6.59876 -645 2 5.7241 2.45518 2.0296 8.37538 -0.331655 9.00677 -646 1 10.7419 2.97566 3.2545 -3.93098 2.36946 -8.35386 -647 2 10.3631 3.83794 3.45313 -5.44824 -1.84651 0.91029 -648 2 10.2755 2.65841 2.45654 4.06882 -1.04864 5.83378 -ITEM: TIMESTEP -90 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.80968 6.6261 17.8375 -14.5778 0.995444 8.41947 -2 2 7.95772 6.60642 18.3334 15.3437 1.8775 -14.2431 -3 2 8.74654 5.99095 17.1112 1.57504 -1.57025 6.7209 -4 1 0.142832 8.36014 6.73441 10.0116 -15.4349 27.0014 -5 2 0.232649 8.20449 5.79462 4.11725 -7.32768 -11.6468 -6 2 0.67494 7.65251 7.20998 -18.6261 25.5606 -16.1468 -7 1 8.65703 0.380136 6.98192 16.3005 -1.0776 2.50655 -8 2 9.57515 0.309779 6.66722 -10.0942 0.994659 4.05519 -9 2 8.27212 1.03395 6.395 -6.58679 0.322126 -3.42087 -10 1 6.47941 1.69165 11.7468 2.00503 -21.4393 -6.03474 -11 2 5.9725 2.29393 12.2744 -13.1143 10.2157 7.12378 -12 2 5.89376 0.920881 11.5936 7.71629 6.15291 -2.33076 -13 1 6.9103 5.50063 2.38437 -35.7814 23.4203 2.69428 -14 2 6.20944 5.92743 2.96221 29.3961 -15.7919 -7.47581 -15 2 6.73166 5.94071 1.53167 10.6635 -7.16691 8.95661 -16 1 16.211 10.2361 16.1124 -22.7966 -2.93172 13.0323 -17 2 16.937 10.2632 15.5246 28.6916 5.0146 -15.8412 -18 2 15.9737 11.152 16.3021 -3.36115 -0.429235 -4.16748 -19 1 10.8196 14.9788 2.33309 -6.31813 -9.42536 4.48609 -20 2 10.7437 14.525 3.19227 -2.25161 -0.175376 -6.3843 -21 2 11.168 15.8375 2.56675 6.6431 8.63317 3.56201 -22 1 17.1655 8.21466 10.9616 20.3007 -11.9207 -19.649 -23 2 16.6876 8.89778 11.4174 -14.8371 14.2918 8.905 -24 2 17.9353 8.67496 10.5709 -5.82559 -3.7293 4.59063 -25 1 14.5981 15.9748 16.3536 13.4587 -18.0704 19.8012 -26 2 13.6875 16.2688 16.3636 -10.2246 8.72504 -7.33216 -27 2 14.6733 15.4751 17.2031 2.63957 5.2712 -15.5493 -28 1 12.1292 13.2811 0.580093 14.6523 -12.0599 13.1814 -29 2 11.875 13.3883 18.3092 -10.372 6.98394 -12.7652 -30 2 11.639 13.8901 1.1449 -2.74566 6.59249 -3.74219 -31 1 9.34925 5.48981 3.82539 12.3818 -0.191077 28.8485 -32 2 8.80634 5.44704 4.61652 7.17551 -1.92534 15.5524 -33 2 8.65833 5.42982 3.20736 -26.4153 -0.989629 -43.3837 -34 1 1.57757 3.9189 11.5719 -21.368 33.8782 -18.8992 -35 2 1.50486 4.82423 11.9434 2.77 -7.29772 -4.79385 -36 2 1.95891 3.38097 12.2317 20.2106 -22.0339 29.781 -37 1 2.11583 6.92705 8.12278 -10.2704 -2.23476 -15.4196 -38 2 2.47676 7.42607 8.85663 6.65774 -1.70501 8.2798 -39 2 2.06913 5.99576 8.38149 2.03129 -2.32531 8.57063 -40 1 5.2846 4.43559 7.83749 -11.1092 26.0267 -7.92074 -41 2 5.42959 3.50305 7.74019 3.58921 -20.4287 3.63869 -42 2 4.59753 4.67739 7.1831 9.16507 -0.464339 6.41033 -43 1 3.36483 2.87842 17.4354 -5.48754 -0.0293267 11.8999 -44 2 4.0122 3.13798 16.7945 16.5223 13.9802 -16.1706 -45 2 2.91387 3.69111 17.7275 -1.08839 -5.27878 2.29607 -46 1 7.51128 5.54904 6.16479 9.71808 2.6671 3.00483 -47 2 8.12131 6.08033 6.71556 -9.69992 -1.44216 -4.10694 -48 2 7.04033 4.98631 6.78947 -1.48399 -2.17988 -0.0590646 -49 1 9.79239 7.0023 12.0333 -12.7203 -1.67256 -9.54047 -50 2 10.0574 6.1295 11.7028 -2.54946 7.94968 0.438659 -51 2 9.0334 7.28866 11.4661 15.1177 -5.87574 8.09476 -52 1 14.1269 3.84395 8.13857 -24.8841 12.3935 -19.8999 -53 2 13.4363 4.47719 7.80064 24.2741 -16.3277 6.83338 -54 2 14.3749 4.15432 9.00462 4.04893 6.4318 14.0535 -55 1 4.52686 17.2232 3.85531 -7.09571 -9.71268 16.0786 -56 2 5.35353 17.6803 4.02689 3.89364 6.28665 -2.88462 -57 2 3.96567 17.7155 3.24673 4.45666 4.6431 -9.26961 -58 1 16.1958 16.5107 10.5377 18.4287 -13.9772 -31.1199 -59 2 15.4454 16.6557 11.0933 -16.6117 1.05393 13.9092 -60 2 15.8645 15.9242 9.81336 4.55855 15.7974 16.2758 -61 1 1.967 4.85121 0.0645769 9.40837 -19.0171 0.778776 -62 2 2.73793 5.10942 0.56616 3.15966 4.76786 17.0447 -63 2 1.80075 5.61055 18.1709 -12.801 18.3624 -15.2179 -64 1 11.1737 13.314 16.4367 2.74473 1.78814 5.72217 -65 2 10.7128 12.4641 16.5748 8.32361 2.87799 -7.58216 -66 2 11.8417 13.1969 15.7431 -5.18043 -7.14508 -0.417807 -67 1 10.0458 10.8999 16.8205 33.4394 -5.51473 9.19041 -68 2 10.5428 10.0531 16.9406 -15.1708 22.1127 -3.77119 -69 2 9.12902 10.6892 16.7607 -22.7906 -6.8787 -3.44008 -70 1 11.889 17.5084 13.4814 3.48745 6.24304 -13.0003 -71 2 12.5913 17.1622 12.8998 -9.91022 -4.16273 6.93206 -72 2 12.0139 18.4633 13.4204 2.43964 2.21886 2.73389 -73 1 6.44228 9.49569 12.2996 9.71147 -12.8692 -34.1322 -74 2 7.06965 9.17025 11.5988 -17.7592 6.4035 17.1392 -75 2 6.97144 10.0526 12.8659 4.91959 6.23922 4.73193 -76 1 16.3022 12.832 2.75135 -12.5209 9.65366 -4.24277 -77 2 17.1598 13.1655 2.44684 -4.70434 0.462679 5.46936 -78 2 15.6996 13.6248 2.74248 12.9928 -20.5688 3.1232 -79 1 0.706696 12.7395 5.83755 -10.6776 2.47735 15.1944 -80 2 1.02688 12.9731 4.95908 -4.07327 -10.4263 -9.29508 -81 2 18.3891 12.5308 5.80039 14.5368 6.4085 -10.1514 -82 1 5.29875 16.3254 18.4501 12.7507 -5.44046 -6.67673 -83 2 5.72604 15.6129 17.9385 -8.69196 7.59677 5.8406 -84 2 6.01274 16.6418 0.375909 -8.3334 1.51688 4.30584 -85 1 0.743878 7.68205 4.10167 -26.7478 -30.2572 33.4946 -86 2 0.179417 7.92019 3.37827 -7.5716 9.21403 -16.4097 -87 2 1.60385 7.98113 3.89879 36.269 17.899 -12.2731 -88 1 3.22103 9.09598 6.53924 -28.7289 15.6764 -27.4701 -89 2 3.63534 8.61301 7.2251 9.03881 -15.9481 23.3571 -90 2 2.25678 8.88215 6.53178 21.3431 5.76786 5.41461 -91 1 7.2773 10.3926 16.241 -1.60955 -9.9776 11.4431 -92 2 6.63502 11.108 16.2935 -0.090439 -0.440245 3.15105 -93 2 7.09074 9.80627 16.9963 -3.87073 10.8392 -3.46734 -94 1 11.0095 0.891279 5.03438 2.23591 -17.8064 16.3849 -95 2 10.8775 1.7336 4.57918 5.69275 -3.07397 -7.72854 -96 2 10.7003 0.188666 4.43596 -0.931337 13.9517 -3.17827 -97 1 4.21583 2.94335 13.1635 9.62289 2.41259 16.4284 -98 2 4.47922 3.3428 14.0131 -5.18172 -0.255184 -10.0037 -99 2 4.1364 2.00091 13.3783 -2.2119 -1.88246 -4.82143 -100 1 8.45625 10.2801 1.81127 9.01648 -22.0588 9.24648 -101 2 8.30671 10.8697 2.54783 -2.77767 16.2884 7.52121 -102 2 8.66335 9.4444 2.27657 -0.852681 8.00384 -10.6723 -103 1 10.2261 1.659 15.4538 -6.06042 8.31352 -11.6288 -104 2 11.1361 1.48308 15.6359 20.1952 -3.56794 7.64131 -105 2 10.2187 1.98601 14.5369 -5.79366 -2.30068 5.3707 -106 1 2.60435 12.742 7.94637 -6.15341 0.568057 0.983218 -107 2 3.03975 13.5699 7.72118 6.64853 3.0435 -2.79803 -108 2 1.95513 12.6117 7.24141 1.86204 -3.09485 1.26562 -109 1 3.88579 11.7956 5.01149 -19.6155 -13.0634 1.96641 -110 2 3.74363 11.1082 5.69355 0.727972 11.568 -8.07528 -111 2 3.05901 11.8342 4.47209 17.5209 1.69759 11.0979 -112 1 6.76239 14.55 16.9383 -0.403452 -2.75277 4.08609 -113 2 7.61561 14.9826 17.0312 2.52456 -1.29817 -0.221044 -114 2 6.44911 14.7692 16.0549 2.09428 -3.60588 -3.74869 -115 1 14.1942 14.5231 3.16652 -5.12336 -14.4242 4.12891 -116 2 13.6899 15.3256 3.31261 0.149267 9.23779 -5.23449 -117 2 13.7696 13.8761 3.7521 4.09464 2.97302 0.255936 -118 1 8.7401 18.0877 16.1157 -15.0544 -15.1521 5.72203 -119 2 9.42706 17.4939 16.3945 -6.08837 -23.732 7.70311 -120 2 9.27218 0.11536 15.7481 8.35971 40.209 -14.9349 -121 1 4.63391 1.71898 4.89 36.0507 -5.82478 -13.0459 -122 2 3.81997 2.19927 4.85319 -16.3674 13.8452 0.00946397 -123 2 5.20292 2.04685 4.14723 -16.8402 -3.94878 19.5369 -124 1 15.0105 12.65 16.5031 22.0082 2.89039 39.0948 -125 2 14.6032 12.5883 17.4132 0.919275 4.87615 -33.2046 -126 2 14.3966 12.5461 15.7793 -22.8851 -3.84554 -8.75239 -127 1 15.7197 18.424 16.8504 13.0838 27.0964 8.25258 -128 2 16.3964 18.519 17.5419 -1.36847 2.51381 -4.544 -129 2 15.6686 17.4972 16.714 -13.5977 -31.6712 -2.03374 -130 1 1.39308 1.32386 16.6798 -9.07755 4.26299 3.83254 -131 2 2.19455 1.8573 16.8358 -13.1892 -10.0845 0.867767 -132 2 0.760663 1.62622 17.366 11.6728 -4.82483 -8.86289 -133 1 18.2416 4.3099 15.966 -4.36834 -5.16176 -14.6355 -134 2 17.7783 3.61219 15.465 8.57404 10.6893 6.25867 -135 2 0.425079 4.50442 15.5034 -5.04787 -4.14191 4.79432 -136 1 12.0688 17.0582 16.1192 -6.60497 -5.44285 54.7429 -137 2 11.374 16.6436 16.7154 18.2098 8.22439 -32.524 -138 2 11.7541 17.1189 15.223 -7.97888 -4.44492 -17.7493 -139 1 16.0987 2.72798 18.2222 -6.94033 2.52412 -3.34156 -140 2 15.6657 3.49187 18.6187 5.88163 2.98889 4.51464 -141 2 15.8079 2.8031 17.3159 -2.77048 -8.0731 -14.4365 -142 1 6.58612 13.762 10.0351 1.63352 -0.32404 13.73 -143 2 6.39624 13.3299 10.8846 2.34483 4.77487 -0.634471 -144 2 6.55421 13.0562 9.39028 1.369 -6.64332 -8.7831 -145 1 10.1169 18.5721 2.70869 27.9004 -1.02691 -4.20355 -146 2 10.7561 0.140951 1.98734 -15.1054 -0.137902 13.7961 -147 2 9.28626 18.3596 2.30468 -14.2521 -4.05351 -7.65243 -148 1 3.07988 17.6804 6.1902 -35.1734 2.13391 -17.3705 -149 2 2.15682 17.7525 5.8242 24.0448 -4.32039 20.662 -150 2 3.55195 17.7661 5.36197 20.4585 -2.58277 -0.69289 -151 1 12.6061 16.7775 7.89366 1.16584 -8.73771 -17.6522 -152 2 11.856 16.1922 7.7211 -0.763759 -4.24653 -1.89641 -153 2 12.3057 17.3353 8.59898 -2.13454 17.8975 18.5826 -154 1 14.8965 15.3132 8.35277 -22.4274 15.9599 0.214205 -155 2 14.2421 15.9941 8.02515 16.4945 -20.4059 13.6979 -156 2 15.4898 15.1572 7.61828 5.37632 7.31151 -11.1374 -157 1 17.8957 18.2766 0.201476 9.69326 -17.5267 -0.973127 -158 2 18.6995 17.7195 18.781 -12.0492 3.04369 -7.3597 -159 2 18.2321 0.401263 0.645934 -1.5685 17.2308 6.22008 -160 1 0.802158 10.4818 1.45184 -19.0828 -29.4994 30.4216 -161 2 -0.0309651 10.0246 1.77565 29.2477 9.1244 -14.7118 -162 2 0.53478 11.1455 0.834437 -7.87366 18.9841 -18.3051 -163 1 1.85308 12.2863 3.27351 -7.97315 5.10175 -10.2215 -164 2 1.42551 11.5849 2.74616 7.16023 4.54594 2.45335 -165 2 2.09673 12.9814 2.63054 -3.38314 -5.43944 9.55244 -166 1 0.718881 17.2977 4.9616 -19.2906 6.0419 1.76293 -167 2 -0.10575 17.7685 5.12875 8.39755 13.2462 -10.2288 -168 2 0.622971 16.5645 5.55208 6.7728 -21.2776 10.1703 -169 1 1.03867 0.919889 9.35844 3.74022 -6.32288 33.4729 -170 2 1.10918 0.592533 10.3007 6.31379 11.0803 -22.721 -171 2 0.269914 0.464458 9.03134 -8.6906 -2.38217 -7.04515 -172 1 16.7862 2.42581 13.3986 14.7457 27.0937 -15.311 -173 2 16.9847 2.74906 12.4891 -5.29709 -2.40963 18.2684 -174 2 16.5429 1.52129 13.2791 -8.06021 -27.7395 3.47759 -175 1 2.69738 16.0066 12.0777 13.1506 -14.7233 12.6976 -176 2 3.02715 15.5922 12.9029 -9.51867 9.47826 -13.4594 -177 2 3.28974 15.6737 11.3809 -2.31502 2.53439 -1.78657 -178 1 16.3754 15.4917 6.11201 -7.25585 -20.1131 3.67265 -179 2 17.3156 15.5044 6.29369 9.86882 2.22778 5.36532 -180 2 16.2073 16.2228 5.51797 -0.959992 10.1027 -9.31738 -181 1 5.7174 5.24337 11.7813 4.42707 -14.1004 -1.48072 -182 2 5.44277 5.99707 12.328 1.64183 -4.11158 -2.88134 -183 2 5.22325 4.47043 12.1002 -4.92771 7.03451 -4.06757 -184 1 15.1242 4.92712 0.766674 18.5408 -12.9138 10.3204 -185 2 14.9855 4.62556 1.67944 -3.08744 4.9541 4.0864 -186 2 14.3291 5.35182 0.492873 -21.4444 10.4963 -5.72763 -187 1 16.3798 16.4926 1.83048 25.9496 20.3657 -34.7081 -188 2 16.3432 16.8093 2.72897 -9.33108 7.61853 14.7037 -189 2 16.7914 17.2408 1.28765 -16.0156 -28.1785 20.3541 -190 1 0.157471 4.87182 3.99278 -9.81132 22.7056 -3.03191 -191 2 0.5332 5.76253 4.03054 -8.2904 5.08609 0.673103 -192 2 0.911036 4.31937 4.01308 22.6258 -22.4944 4.73784 -193 1 2.97603 15.0857 15.1688 -3.76699 16.0764 -9.28303 -194 2 2.87698 14.8354 16.0845 -1.20729 -14.2266 12.1787 -195 2 2.48786 15.9266 15.1702 1.40562 1.39337 -6.33902 -196 1 1.10637 14.6846 9.51596 31.8836 22.2572 14.4694 -197 2 2.01065 14.9183 9.89233 -34.4229 -12.9306 -18.6629 -198 2 1.03031 13.7317 9.56194 1.94445 -7.79278 4.16037 -199 1 13.55 16.5172 11.5597 10.1041 14.0808 -3.72584 -200 2 13.3442 17.2549 10.9555 -5.19335 -6.01443 7.16005 -201 2 13.1025 15.7566 11.183 -9.96101 -8.306 -1.961 -202 1 4.75563 1.55237 0.702796 10.3802 -26.0161 11.0265 -203 2 4.32304 2.05314 0.014379 -14.7339 5.42124 -2.63334 -204 2 4.14265 0.839056 1.00315 4.15161 14.819 -1.07901 -205 1 1.52656 18.6416 11.9009 -8.95117 16.8483 13.4998 -206 2 1.43825 0.48402 12.7573 3.56637 -8.71242 -18.201 -207 2 1.98334 17.8196 12.0914 3.68072 -6.34965 2.55122 -208 1 11.4393 10.1383 4.17836 -13.7636 4.05009 -8.78245 -209 2 11.3903 10.5027 3.28707 -1.50281 2.58284 -2.63304 -210 2 12.3655 9.96172 4.28712 17.4192 -2.53267 8.67839 -211 1 8.18359 12.1636 3.86104 -21.222 -14.272 -14.5003 -212 2 9.05859 12.5239 4.0446 -0.40723 6.23371 14.3883 -213 2 7.56046 12.2135 4.62832 23.1203 4.46306 -6.77507 -214 1 14.593 4.04535 3.38111 7.28555 -5.40785 -19.1504 -215 2 15.2127 4.15408 4.10794 5.52844 2.67895 3.03112 -216 2 13.7536 4.35259 3.70606 -13.9578 6.65801 6.31365 -217 1 5.72323 1.65443 7.61073 34.4 15.7962 37.2038 -218 2 5.13785 1.03104 8.01585 -19.7408 -11.9782 7.15973 -219 2 5.42676 1.78462 6.74294 -17.7695 -4.7826 -52.6001 -220 1 17.8873 1.06414 4.83181 6.8154 -0.232455 -4.71432 -221 2 18.4369 1.21178 4.04718 -2.79964 -1.76243 2.38037 -222 2 18.3376 1.55744 5.53048 -5.83965 -0.882229 4.9581 -223 1 6.85055 9.23648 4.54341 6.32277 -8.10519 -4.82585 -224 2 6.75809 9.38079 5.49182 3.88959 4.29486 1.07151 -225 2 7.79379 9.02149 4.39148 -10.7358 1.98669 4.12637 -226 1 2.55801 14.782 2.06648 -8.35029 -12.2797 -25.7867 -227 2 3.24533 14.7191 2.71695 15.3489 0.778658 13.055 -228 2 2.98421 14.5338 1.22242 -9.03529 10.4097 12.3511 -229 1 17.2667 12.9721 13.1114 -20.9369 36.2303 -2.57416 -230 2 16.4188 13.4451 13.3365 18.5804 -22.1292 -0.415694 -231 2 17.7749 13.7311 12.7641 -0.529191 -13.9074 0.965338 -232 1 14.8416 10.5583 1.56689 -2.78575 22.6182 14.2458 -233 2 15.4799 11.2066 1.96334 -16.8252 -10.4846 -9.71145 -234 2 13.9405 10.9259 1.71943 20.5685 -8.6057 -5.43477 -235 1 5.6352 6.7176 4.51351 -9.14706 -11.8638 3.15016 -236 2 6.0003 7.60062 4.53525 2.53301 15.852 -6.04122 -237 2 6.16933 6.24394 5.16122 6.25334 -1.18144 -1.3834 -238 1 8.0084 8.26626 10.2701 -4.49752 14.9075 -15.7864 -239 2 8.53054 8.9292 9.77232 -0.437986 -11.1673 11.0277 -240 2 7.35426 7.95022 9.61336 5.97292 -3.64509 13.4454 -241 1 13.4616 18.4657 5.71166 17.1322 -6.35165 -5.45305 -242 2 12.613 0.202175 5.51075 -18.0122 19.0124 -5.00284 -243 2 13.2587 17.813 6.37409 -3.85709 -10.1746 14.3256 -244 1 0.0252945 2.56986 0.408061 0.439602 -5.22175 -5.84652 -245 2 17.7844 2.56336 0.0359587 -11.4993 -5.28871 3.98864 -246 2 0.277142 3.47535 0.26454 16.627 13.7372 -0.461998 -247 1 12.8639 10.8267 9.72576 -55.6075 31.3565 -11.278 -248 2 11.8723 10.9451 9.72713 30.8534 7.0313 -2.47663 -249 2 12.8724 9.89108 9.83244 20.4971 -22.7651 5.79467 -250 1 0.607625 12.2828 11.1117 24.514 -2.72666 -9.78403 -251 2 18.2964 12.3126 11.1603 -11.5713 5.22338 7.13378 -252 2 1.01642 12.6716 11.9034 -8.98148 -2.79725 -0.830812 -253 1 5.29539 7.3549 13.3064 -7.85772 10.5518 3.63543 -254 2 5.70599 8.16396 12.9287 -0.549664 -12.4206 10.9242 -255 2 5.67568 7.22584 14.1948 2.69835 3.31529 -9.72444 -256 1 1.17555 6.77844 11.9244 -33.9372 -12.3631 -14.3141 -257 2 0.259637 6.99751 11.6106 25.929 -3.06653 9.08527 -258 2 1.58097 7.60434 12.1643 7.59492 14.5493 8.35248 -259 1 15.5141 9.76806 12.4302 -1.8656 17.4266 8.04916 -260 2 15.0855 10.6363 12.2204 12.2826 -22.7347 2.36453 -261 2 16.0019 9.91808 13.2494 -6.58523 -0.731675 -3.13373 -262 1 16.4968 12.5534 5.50851 9.37615 -29.7593 -4.66799 -263 2 16.3074 13.4744 5.68685 -5.44524 15.7433 -9.11055 -264 2 16.3732 12.3531 4.54775 0.322938 17.9758 14.7603 -265 1 6.32376 9.8903 0.169934 -28.7401 -0.365509 -5.18995 -266 2 5.50824 10.2805 0.557378 14.6251 -5.00462 -6.15541 -267 2 7.04833 10.2225 0.694867 12.727 0.898893 11.9262 -268 1 12.1515 6.04661 4.01259 -24.0177 -36.8905 11.864 -269 2 12.231 6.67099 3.30768 1.42994 18.9462 -13.2923 -270 2 11.2548 5.64061 3.89367 21.868 15.3866 4.7403 -271 1 0.316109 12.8908 0.0158726 1.97018 -1.90411 4.82087 -272 2 18.784 13.4984 0.752127 -2.36898 -0.989285 -3.79 -273 2 18.4247 13.2164 17.9164 2.23727 -3.47257 5.47524 -274 1 3.55093 0.0615484 8.6771 30.4928 -5.90286 -4.02028 -275 2 3.49841 18.2151 7.84215 -7.8476 4.22576 -1.41638 -276 2 2.7473 0.557235 8.76228 -21.0031 4.54937 0.225707 -277 1 7.3901 17.5352 4.48573 6.23592 32.7201 -14.6481 -278 2 7.69571 18.4853 4.57976 -11.8279 -33.7706 3.32686 -279 2 7.33788 17.4402 3.51852 2.74261 -6.71083 9.2357 -280 1 9.25 17.16 12.2333 -3.7288 14.5824 3.61249 -281 2 9.26512 16.5009 11.5521 -3.80961 -18.6559 -12.0666 -282 2 10.1634 17.2094 12.5273 3.6148 1.53928 10.2644 -283 1 13.402 13.1082 7.90091 0.220655 -14.9059 29.302 -284 2 13.4302 12.436 8.64233 -5.21958 14.4877 -25.9571 -285 2 13.929 13.8525 8.23076 3.39805 -3.2421 -4.10773 -286 1 14.8025 2.90677 15.4495 23.2091 4.40575 2.70159 -287 2 14.1483 2.29946 15.1328 -14.8482 -16.0174 -4.02081 -288 2 15.4935 2.87296 14.7763 0.208871 3.12507 -3.30872 -289 1 9.90762 15.6519 16.9195 -4.56731 4.54647 -2.1455 -290 2 10.1638 14.7845 16.5964 9.48907 -4.21512 -5.5698 -291 2 9.51082 15.4442 17.7618 -6.39245 0.962418 13.4848 -292 1 11.1953 8.50068 16.6178 -6.68582 -9.72424 -8.69684 -293 2 10.4052 8.01271 16.3331 5.65618 1.52157 -2.37675 -294 2 11.7201 7.85843 17.0918 5.14472 -5.56789 7.7477 -295 1 3.97964 18.2216 16.8609 -11.5365 11.132 -5.80894 -296 2 4.44261 17.5481 17.3724 7.79342 1.98205 9.06349 -297 2 4.16759 0.471834 17.2017 1.31413 -17.4358 -0.663005 -298 1 2.27286 4.25928 8.9046 8.30035 -0.830932 12.3077 -299 2 3.22373 4.0264 8.87035 -15.4899 4.40379 3.11293 -300 2 1.97207 4.14495 9.83591 10.7423 -1.42059 -17.2737 -301 1 9.92348 10.3926 9.8203 -1.21029 -1.85278 -24.2235 -302 2 9.36782 11.1029 9.49607 0.630055 7.16446 -2.16893 -303 2 9.82869 10.3844 10.7566 4.49005 -1.30636 29.4196 -304 1 9.77911 0.915187 10.8241 -1.58049 4.53496 -1.50662 -305 2 9.30516 0.126632 11.1017 -0.152878 -7.87834 6.94802 -306 2 9.15539 1.38664 10.2518 4.51752 0.176684 -4.82426 -307 1 9.1489 15.1729 10.179 6.96198 -6.50551 5.53221 -308 2 8.91001 15.8322 9.53904 -4.06695 15.478 -9.20984 -309 2 8.38415 14.5913 10.1616 -4.75674 -5.76082 4.02117 -310 1 0.743465 9.68917 10.1631 30.9903 9.57445 -5.37239 -311 2 0.884314 10.6156 10.4664 -8.35327 -15.1374 -2.2352 -312 2 1.62506 9.41264 9.82336 -24.2866 3.90606 7.18729 -313 1 17.1113 4.7779 8.02102 2.26389 -23.2748 8.45538 -314 2 16.3418 5.309 8.21811 -5.84575 9.78705 2.38191 -315 2 17.0463 3.99595 8.60382 3.74785 14.695 -9.14029 -316 1 14.847 14.6269 0.171171 -19.7527 -14.4968 -14.2937 -317 2 15.5321 14.9161 0.755334 10.0132 13.2257 15.972 -318 2 14.1228 14.2968 0.729437 5.50655 3.69994 -2.14986 -319 1 3.90456 11.0507 9.5998 -4.69832 -0.998696 -0.0493525 -320 2 3.86255 11.1688 10.552 1.28841 5.10968 9.84865 -321 2 3.27063 11.6917 9.24194 0.0177884 -1.71993 -8.82733 -322 1 11.433 10.7439 1.41897 29.5023 2.97313 10.7876 -323 2 11.6019 11.6536 1.12948 3.85703 -2.03295 -2.25776 -324 2 10.504 10.6413 1.35913 -35.0433 -4.68689 -6.35229 -325 1 13.1835 7.21214 12.6412 -8.23521 -20.1104 -3.47812 -326 2 14.127 7.05932 12.5127 3.33109 -0.638199 4.03042 -327 2 12.8061 6.29857 12.6985 3.22225 19.9882 2.50286 -328 1 9.65928 1.95745 0.843925 10.2182 6.36996 -3.06277 -329 2 8.81763 1.63483 0.51897 -5.65357 2.11518 2.03686 -330 2 10.1334 2.26536 0.0610097 2.29468 0.231167 4.03759 -331 1 10.5974 13.4461 4.57973 -2.39764 -3.17335 8.92217 -332 2 11.4415 12.9723 4.66721 0.170993 3.79528 3.71784 -333 2 10.3828 13.7711 5.47244 5.6647 1.39651 -7.04866 -334 1 14.5805 1.64306 10.9903 3.01891 29.9103 -7.34195 -335 2 15.4206 1.31489 10.661 2.43812 -13.4824 -3.17866 -336 2 14.6923 2.61327 10.8523 -8.77415 -13.7688 6.87151 -337 1 14.4577 12.0498 11.5485 -29.7481 -1.24334 12.4997 -338 2 15.1787 12.3182 10.9897 13.6492 5.38623 -14.4259 -339 2 13.7324 11.7114 10.9784 17.3586 4.51945 3.50834 -340 1 8.16823 5.15587 9.894 -28.9634 21.8059 19.126 -341 2 7.25961 5.26999 10.2972 28.5921 -4.04796 -11.5402 -342 2 8.23961 4.23455 9.67377 -1.01689 -19.4985 -4.69706 -343 1 1.66839 17.0027 18.4477 20.9596 26.331 -27.2012 -344 2 2.19503 17.5247 17.7665 -16.8758 -18.2972 22.1195 -345 2 1.83767 16.0826 18.2308 2.67698 -10.8321 1.22526 -346 1 1.40907 17.4029 15.3161 -1.8056 14.8407 8.29727 -347 2 1.4134 18.2156 15.8633 3.96238 -8.68525 -7.97287 -348 2 0.471831 17.1989 15.2085 1.34275 -7.61847 -1.46046 -349 1 3.49459 5.75594 6.06077 -10.0958 -15.2551 6.44531 -350 2 3.00844 6.4276 6.56158 3.56089 -0.0685925 -1.76679 -351 2 4.03572 6.19023 5.40706 10.0519 13.1926 -8.23224 -352 1 12.6765 9.5142 14.2706 -5.75697 27.7722 -14.2581 -353 2 13.0673 8.79775 13.7668 1.15853 -14.5514 3.26719 -354 2 12.382 9.20431 15.1249 -1.95515 -14.6959 8.85488 -355 1 4.11243 15.2112 7.12768 13.4261 4.57048 -4.21166 -356 2 3.68336 15.9917 6.77855 -13.243 7.84695 -2.74865 -357 2 5.05149 15.4218 6.9541 -4.34911 -9.58911 5.5273 -358 1 0.807347 8.85082 15.1137 12.1653 -16.291 -5.21716 -359 2 0.579225 9.7725 15.0704 -11.1033 15.5539 4.56692 -360 2 1.61112 8.83255 14.5724 -2.7466 -7.45742 -2.63208 -361 1 12.955 8.28126 10.1315 4.47425 -26.4789 2.77461 -362 2 13.6724 7.69661 9.75218 -12.3213 15.4477 18.6624 -363 2 12.7996 8.04439 11.0766 12.5165 -4.13221 -14.8671 -364 1 15.2413 7.99312 3.46307 21.2061 37.6089 -22.4299 -365 2 14.4756 7.7211 2.94477 -5.95544 -17.8301 8.14742 -366 2 15.6187 7.46858 4.17258 -15.9179 -18.0198 8.83427 -367 1 17.1356 6.70525 18.6386 6.47512 25.7091 -12.2215 -368 2 16.6963 5.89525 0.233999 -10.309 -8.75159 3.76643 -369 2 16.4339 7.33237 18.3357 11.2115 -13.3479 10.1501 -370 1 8.91981 7.02641 7.93476 -17.5815 -13.9195 9.00305 -371 2 9.83812 7.25537 7.853 19.0031 7.73693 -0.560136 -372 2 8.849 6.45385 8.72921 -1.20537 6.38433 -11.1549 -373 1 12.4784 0.471427 1.2 -1.5382 -11.3036 2.52426 -374 2 13.1724 0.955828 1.65737 6.96212 2.95671 -0.139484 -375 2 12.8855 0.124586 0.40059 -1.81614 4.12295 -0.743523 -376 1 5.7338 15.0104 14.483 3.21537 -3.99883 -6.81615 -377 2 4.79914 15.0689 14.6899 -13.3072 1.49299 3.3932 -378 2 6.00174 15.8892 14.196 3.10174 7.95604 -0.192962 -379 1 3.73322 6.46389 1.74186 4.97145 -11.2752 -15.478 -380 2 3.41061 7.27444 1.33141 -3.85483 5.16021 2.72417 -381 2 3.71896 6.61791 2.68352 1.01313 6.07651 8.98471 -382 1 3.85612 11.3357 12.3214 9.74989 2.64833 3.1782 -383 2 4.70398 11.747 12.5616 1.03181 -4.89631 -4.08494 -384 2 3.21292 11.8498 12.8111 -10.0411 9.11388 1.93155 -385 1 5.31882 3.86098 15.7247 -14.6622 43.9235 8.42988 -386 2 6.03513 3.29574 15.4808 24.4173 -17.8012 -3.50674 -387 2 5.69837 4.77513 15.8552 -8.87612 -28.0013 -6.19005 -388 1 14.0506 10.0984 4.70507 12.9021 5.9963 -48.2497 -389 2 14.373 9.82203 5.54065 6.42583 -15.3441 32.1568 -390 2 14.6577 9.66966 4.04903 -16.6446 6.96016 16.1133 -391 1 7.63016 17.2999 9.07082 4.88589 -1.83029 4.08955 -392 2 7.05774 17.6443 9.76408 -9.77236 -5.61109 0.722829 -393 2 7.90646 18.0745 8.58282 6.82018 7.73796 -12.3688 -394 1 4.54853 14.4989 3.92298 4.51049 -12.0827 -19.4455 -395 2 4.48676 15.3439 4.34231 1.7531 23.2793 6.06498 -396 2 4.47875 13.8474 4.61218 -0.893081 -14.6097 11.9436 -397 1 14.1162 7.44072 15.859 5.72353 -2.97717 1.52707 -398 2 14.8925 7.45204 15.2793 -3.03398 0.324075 5.79835 -399 2 14.4079 7.84098 16.6936 -1.38652 -1.7593 -3.67135 -400 1 2.91046 18.3824 1.92161 -14.6763 12.8451 -3.99897 -401 2 2.56811 17.7851 1.23066 -1.64793 1.84374 10.7046 -402 2 2.14175 0.293363 2.23042 22.3557 -16.8939 -8.97037 -403 1 8.00583 1.57089 4.46736 31.4122 8.97246 -10.4438 -404 2 7.40416 1.98491 3.8452 -8.42929 2.78546 -1.25861 -405 2 8.8818 1.75969 4.05638 -17.375 -7.71187 12.4181 -406 1 2.50572 14.1939 17.7606 -21.3738 -1.77578 0.320632 -407 2 1.88811 13.4733 18.0291 6.14349 16.4853 -5.08899 -408 2 3.36784 13.821 17.8832 22.941 -11.7322 7.4453 -409 1 0.984409 1.95477 13.9081 14.9076 0.866869 -10.4657 -410 2 1.09683 1.70126 14.8211 1.02253 -2.39927 14.2505 -411 2 18.6933 2.04344 13.7674 -16.8072 2.56857 -0.576968 -412 1 4.29327 0.177122 13.8951 16.4248 3.49785 -13.6548 -413 2 5.17049 18.4046 13.9646 -5.43827 4.9033 -2.01246 -414 2 3.78721 18.4389 14.598 -10.2443 -5.04864 16.3534 -415 1 7.35353 0.990853 18.4538 -34.7507 -7.39683 16.7648 -416 2 7.55815 0.737816 17.5561 -3.16307 -6.20953 -15.156 -417 2 6.35665 0.974064 18.6083 33.4978 7.02218 -7.3799 -418 1 15.8311 18.4256 13.8966 -40.0758 9.01377 -20.0242 -419 2 14.87 18.5763 13.7207 27.6408 -4.60797 -2.68704 -420 2 15.8417 18.2976 14.8321 10.6174 3.57585 21.6768 -421 1 10.2864 4.58419 16.2444 -24.4222 -37.2091 -9.88285 -422 2 11.2299 4.68793 16.3674 13.142 -4.29349 -1.09379 -423 2 10.1171 3.59079 16.124 8.18179 40.05 5.52806 -424 1 15.8917 17.7071 4.46459 -20.0388 -20.4222 2.09772 -425 2 16.4651 18.4471 4.57513 18.3163 24.2221 3.8588 -426 2 15.0409 18.0029 4.83395 4.42355 -1.752 -6.47073 -427 1 6.88773 17.6166 13.9821 -38.4037 0.167583 13.1844 -428 2 7.46394 17.6315 14.7417 15.8748 3.42447 12.5511 -429 2 7.41699 17.4009 13.2391 27.9809 -3.71977 -23.5355 -430 1 13.1764 6.43911 6.52144 -5.83912 -0.258919 -12.4557 -431 2 14.0695 6.77261 6.34605 -1.47407 -3.35023 -0.470203 -432 2 12.7466 6.3372 5.63472 11.513 2.45032 19.1456 -433 1 7.86196 2.29978 9.4638 -2.97627 -2.7765 -21.1046 -434 2 7.31086 2.09746 10.2267 -8.88065 1.6173 3.7395 -435 2 7.37564 1.98398 8.66115 7.69705 6.95472 18.2428 -436 1 15.1916 14.7366 13.8236 -12.2847 5.72199 -1.13466 -437 2 14.8954 15.0381 14.6996 2.36081 -1.57038 -3.3629 -438 2 14.579 15.1371 13.1848 7.3504 -2.29354 4.97967 -439 1 9.39483 8.42303 3.86324 -21.5436 -11.8424 -10.9865 -440 2 10.2164 8.84977 4.07537 16.3384 7.87643 5.27894 -441 2 9.57157 7.47345 3.83359 1.44741 0.673327 1.03302 -442 1 17.655 13.5671 16.4489 -7.58846 13.4511 -15.7424 -443 2 16.7203 13.3469 16.3992 -7.59268 -4.18946 5.70215 -444 2 17.688 14.4057 15.9472 10.2114 -8.11811 3.61388 -445 1 4.94979 10.486 2.86622 25.3355 -10.7625 -10.0508 -446 2 5.84023 10.0991 3.03563 -22.0316 6.96347 2.01482 -447 2 4.71704 10.9487 3.67532 0.603793 8.46932 2.75775 -448 1 3.68042 8.39717 9.8747 -7.87972 -17.3414 17.5888 -449 2 3.759 9.34077 9.71499 3.24219 9.53521 -0.886609 -450 2 3.55014 8.28216 10.8428 3.92085 5.02512 -16.6805 -451 1 15.9973 6.92061 5.87772 4.82031 -5.03924 3.59177 -452 2 16.6812 7.41263 6.34454 2.21588 0.961055 0.440265 -453 2 16.3186 6.0008 5.83915 -7.41322 12.2727 -5.03736 -454 1 15.3004 7.2666 8.94213 -32.1238 -12.1179 -31.7334 -455 2 15.9839 7.55437 9.51768 24.5834 17.5628 17.3411 -456 2 15.1488 7.91682 8.21973 7.72693 -8.10504 16.1569 -457 1 6.21705 12.8062 12.747 -22.7002 13.2796 -10.093 -458 2 7.05571 12.494 13.0465 21.6431 -16.5072 9.89045 -459 2 6.01919 13.5682 13.3077 2.09027 1.41895 1.21426 -460 1 12.1299 4.57596 13.1432 22.4432 17.9492 20.1123 -461 2 12.1793 4.58175 14.1216 4.56317 3.76233 -12.2652 -462 2 11.3861 4.04706 12.9369 -26.6961 -18.2025 -7.73732 -463 1 11.4375 8.07047 7.90979 27.6542 -15.5792 16.7856 -464 2 12.1952 7.52933 7.56059 -23.0528 10.899 -6.13628 -465 2 11.6627 8.11033 8.86659 -7.72222 6.32108 -19.0792 -466 1 16.9453 10.7968 7.63148 -3.5821 -10.5143 21.6719 -467 2 17.6495 10.1525 7.46889 2.86773 -0.504685 -4.5375 -468 2 16.8108 11.3218 6.85057 1.29813 10.4979 -20.4226 -469 1 5.19425 18.0282 10.6847 0.056878 3.62778 8.77145 -470 2 4.66571 17.4143 11.2104 4.95394 3.09506 -2.12913 -471 2 4.57063 18.3664 10.0251 3.33377 -5.62986 -0.929046 -472 1 7.60987 17.4226 1.56636 -8.76834 11.2024 10.6057 -473 2 8.12097 16.6429 1.35059 3.07922 -5.96866 -14.3061 -474 2 7.62904 18.066 0.842261 4.5937 -2.56699 -0.219584 -475 1 1.93734 12.9421 13.6328 4.51097 2.01356 -10.2989 -476 2 1.33249 12.4003 14.1383 -4.04092 -5.16916 8.28012 -477 2 2.1441 13.7105 14.1828 3.43289 -0.0153047 1.69165 -478 1 9.36109 6.77295 14.8254 28.0404 -16.4025 -23.0383 -479 2 9.79586 5.92856 15.0909 -10.7826 13.1246 6.51236 -480 2 9.73683 6.91972 13.9197 -17.1545 2.79671 17.5547 -481 1 15.2759 4.38629 10.7467 0.911226 -10.0818 1.35121 -482 2 16.2063 4.08729 10.7712 -9.28003 7.88291 1.38983 -483 2 15.15 4.95989 11.5268 6.34994 -5.62458 -10.0329 -484 1 11.4488 6.21672 0.0274361 8.35139 15.4334 1.07365 -485 2 11.547 5.26836 -0.0918922 -6.12153 -5.65013 -4.62095 -486 2 10.5221 6.46299 18.5238 -1.7877 -10.3718 -2.04901 -487 1 18.4903 11.4194 14.9121 8.77287 -18.4144 -27.074 -488 2 18.1021 11.8559 14.1353 -5.2902 0.217957 4.39134 -489 2 18.3331 12.0271 15.6113 -5.23497 22.6985 22.6894 -490 1 7.12593 9.28496 7.31024 -23.9992 -6.07508 6.39318 -491 2 6.74279 8.45494 7.66169 4.89732 10.9664 -5.80838 -492 2 8.06011 9.1434 7.29118 23.2007 -3.69072 -2.70719 -493 1 18.3302 15.3588 12.1663 1.84912 0.0598217 5.47138 -494 2 0.628985 15.4631 11.9685 -1.01298 4.74778 -2.81479 -495 2 17.8359 15.8974 11.5264 -1.18931 -3.22386 -0.556154 -496 1 16.5345 4.36456 5.22425 -62.6276 -15.6665 42.2949 -497 2 16.4135 4.0372 6.15475 14.4043 4.47956 -24.0603 -498 2 17.4334 4.499 5.03806 48.2264 1.34274 -11.6623 -499 1 17.733 3.12037 10.7685 2.78093 13.2032 15.2159 -500 2 18.62 3.27348 11.1411 -3.87004 4.46435 -8.2182 -501 2 17.7411 2.21797 10.4818 -1.03268 -21.1847 -12.2715 -502 1 12.2988 18.6545 10.1426 21.4258 -12.4002 -10.8053 -503 2 11.5002 0.459945 10.3706 -28.4452 4.23152 6.39845 -504 2 12.9389 0.72089 10.1511 12.8533 4.08749 0.539844 -505 1 10.4313 9.72872 12.541 3.98701 -3.38274 8.58973 -506 2 11.1703 9.84044 13.1623 -1.01011 3.74187 -3.45859 -507 2 10.4039 8.77038 12.4204 -3.66163 0.188688 -4.07709 -508 1 0.615048 2.63664 7.2276 -9.26807 24.3162 -18.5585 -509 2 0.353188 3.56967 7.37092 2.19049 -16.4853 1.00686 -510 2 0.949026 2.32684 8.06684 4.15829 -4.72879 9.31366 -511 1 0.333537 15.2707 6.93805 -1.63763 -14.4268 -44.2284 -512 2 0.559673 15.3175 7.85021 9.94673 -3.51892 30.6084 -513 2 0.629693 14.3791 6.62643 -7.55161 17.6489 9.10591 -514 1 17.0527 6.91364 14.9743 11.0217 0.359412 -1.38417 -515 2 17.7989 7.54943 14.9113 -7.11537 -10.2599 3.19545 -516 2 17.3979 6.08953 15.3732 -1.90278 10.2985 -1.25317 -517 1 9.14167 12.5321 7.98456 -51.8007 8.58975 -7.36144 -518 2 9.48882 11.7504 7.57305 13.8522 -18.8219 -15.7166 -519 2 8.22261 12.6161 7.58551 34.0094 -0.937982 16.6367 -520 1 1.15656 1.63828 2.76743 -9.76481 2.77041 -4.10292 -521 2 0.864287 2.18836 2.03128 -7.19413 -5.97378 -5.55322 -522 2 1.70002 2.22125 3.28253 11.7483 7.29404 14.7886 -523 1 4.17339 15.1305 9.84913 -14.3711 5.0779 2.99988 -524 2 3.91961 15.3463 8.93389 10.9385 -4.50851 5.90843 -525 2 5.03476 14.6902 9.78793 -0.575875 2.49321 0.528438 -526 1 7.3951 2.27992 14.8377 -1.12966 16.8522 -8.99686 -527 2 7.16414 1.54106 14.2639 1.26623 0.276941 -0.531744 -528 2 7.65338 3.03331 14.2573 -5.05472 -19.0282 8.30824 -529 1 18.3172 14.5403 2.1483 15.3986 5.40572 3.08201 -530 2 0.535799 14.8642 2.50804 -16.0996 -1.12956 -11.071 -531 2 17.7238 15.3001 1.99479 6.48993 -0.927096 4.3539 -532 1 10.0475 2.68059 12.9077 -3.02015 -13.9614 -15.6621 -533 2 9.89167 2.00033 12.2018 7.6523 15.7956 13.7679 -534 2 9.26985 3.25658 12.875 1.66072 1.15674 0.355625 -535 1 2.93978 8.85687 13.107 17.7725 7.3386 -7.69378 -536 2 3.37522 9.71823 12.8547 -12.3312 -24.1388 6.15133 -537 2 3.67473 8.22279 13.2377 -8.38529 8.44125 1.12687 -538 1 3.27106 8.61507 3.79074 -8.49716 -38.7584 59.7131 -539 2 3.66196 9.22584 3.22278 26.3747 36.1018 -32.8858 -540 2 3.70281 8.77413 4.67945 -18.9434 -3.96308 -29.2422 -541 1 5.92777 7.2521 8.64891 -10.8881 -6.62505 3.42768 -542 2 5.84919 6.30478 8.465 1.79189 -1.90292 -1.42585 -543 2 5.07694 7.48175 9.0605 5.83384 2.94932 1.14829 -544 1 14.8827 1.64134 1.82872 -12.6885 -28.1567 -9.76357 -545 2 15.1087 2.39997 2.36476 0.314968 13.4446 -1.58597 -546 2 15.1034 1.73075 0.884031 8.80659 10.9019 15.543 -547 1 8.66156 14.9913 0.655877 15.6167 -4.79217 23.7466 -548 2 9.42437 14.9505 1.28455 -14.0351 0.988592 -13.753 -549 2 7.99981 14.403 1.0655 -3.22335 6.28365 -6.24421 -550 1 15.4067 1.46647 7.20695 -8.82589 -12.8718 -0.882757 -551 2 14.775 0.932663 6.69065 9.74374 4.52972 3.50353 -552 2 14.8641 2.16562 7.57814 -1.0399 11.0322 0.525673 -553 1 4.92475 12.8978 18.4559 2.19674 -3.23744 10.1082 -554 2 5.23586 12.8997 0.738081 -1.33722 2.66651 -10.6279 -555 2 5.70033 13.1343 17.9365 -0.0827318 6.23371 -0.0935372 -556 1 15.3819 8.68528 18.0932 8.72121 10.5448 -14.8557 -557 2 15.8142 9.23534 17.405 -7.78496 -12.8196 8.73029 -558 2 15.2566 9.31777 0.164984 -6.85428 -0.586954 10.5179 -559 1 12.0126 3.13082 18.276 9.47145 -1.72319 12.159 -560 2 12.2482 3.16999 0.564179 -5.55591 0.644277 0.165862 -561 2 12.5655 2.41012 17.9461 -5.90061 -0.236568 -11.7395 -562 1 13.2006 12.6959 5.14014 6.0546 -4.02499 4.06103 -563 2 13.6294 11.8271 5.0147 -6.69767 7.2237 -2.15456 -564 2 13.3727 12.9234 6.07289 -1.67526 -4.52376 -7.3865 -565 1 6.1651 7.14436 0.195504 -22.0894 -12.2339 1.18179 -566 2 6.12052 8.09409 18.9477 10.183 13.9972 -1.43251 -567 2 5.2591 6.87987 0.448218 12.567 -4.05161 -1.41715 -568 1 17.6881 15.878 14.8655 -1.85909 5.77814 22.6605 -569 2 16.7739 16.1608 15.0761 11.3822 -6.39517 -19.8211 -570 2 17.8371 15.675 13.9293 -11.1648 4.64831 -4.02463 -571 1 13.1067 0.88062 16.8301 -1.16362 5.09418 6.26073 -572 2 14.0188 0.56665 16.8428 4.80395 1.33473 -1.08149 -573 2 12.5822 18.7235 16.7479 -0.784604 -6.20947 -5.79489 -574 1 10.8701 14.5014 7.48366 30.6398 4.5327 -13.288 -575 2 10.1924 13.8927 7.76637 -8.27046 -6.89901 6.40521 -576 2 11.688 13.9665 7.40985 -13.0568 5.23738 5.47236 -577 1 17.7216 8.3975 2.13341 -5.03714 18.392 15.6468 -578 2 16.8261 8.35978 2.51012 1.26608 -2.81583 -3.60077 -579 2 17.7343 7.78208 1.41002 -5.68948 -14.3091 -15.2975 -580 1 12.4651 7.83121 2.02849 6.21002 21.8293 -0.701234 -581 2 12.2371 8.77742 1.88873 1.61752 -16.1639 -0.0618129 -582 2 12.1801 7.35781 1.23988 -4.06145 -2.69746 -4.32972 -583 1 11.9912 14.5504 10.3779 26.255 2.08103 -27.6641 -584 2 12.3772 14.5828 9.46952 -12.6474 -4.22617 24.8662 -585 2 11.0517 14.669 10.2537 -15.8484 3.20565 2.09431 -586 1 6.76727 6.87556 15.5462 0.393734 11.8444 22.477 -587 2 7.69535 7.12306 15.3658 -7.56189 -7.86407 -0.973014 -588 2 6.54154 7.32616 16.388 3.13619 -10.9433 -13.6985 -589 1 7.93405 4.43454 13.181 3.70457 37.9343 33.3332 -590 2 7.23909 4.66367 12.5613 -7.79541 1.00974 -8.53955 -591 2 7.95717 5.24214 13.788 5.6586 -32.0049 -23.1645 -592 1 13.3208 12.2124 14.3278 -1.85908 1.78375 8.34338 -593 2 13.1627 11.2597 14.246 -0.36998 0.633125 0.823702 -594 2 13.6236 12.4909 13.4584 3.579 0.31603 -3.71376 -595 1 14.5678 9.48203 7.30395 8.22624 -5.55489 -6.16459 -596 2 15.3274 10.0218 7.53849 6.73854 1.05081 2.13221 -597 2 13.8344 9.86252 7.77014 -14.2105 5.15772 9.40205 -598 1 12.6689 16.8584 3.2838 3.32354 22.4122 -6.02395 -599 2 12.8251 17.4603 4.02708 -0.185303 -8.85949 -0.0347213 -600 2 12.7374 17.4469 2.50984 -1.71014 -6.46341 4.85536 -601 1 0.984375 7.0735 17.3432 34.0501 -3.91376 2.11413 -602 2 0.125246 6.96907 17.7347 -25.3968 2.18392 3.09576 -603 2 0.950307 7.67775 16.5933 -9.77339 5.8232 -4.41721 -604 1 13.0022 4.84407 15.777 5.081 -10.3329 -5.56354 -605 2 13.7485 4.25418 15.5901 -10.0146 -2.33354 7.04552 -606 2 13.4521 5.67804 15.8535 -1.12386 24.7122 1.66863 -607 1 2.36131 3.40053 5.10919 -9.6311 -14.0051 -9.38531 -608 2 1.85776 3.14724 5.88615 -5.89279 -11.6191 4.05299 -609 2 2.64546 4.27356 5.34111 14.5219 19.3293 2.74972 -610 1 8.16093 10.9198 13.7208 -5.48668 -10.5203 36.1407 -611 2 8.01338 10.5218 14.6488 11.4544 18.6016 -43.3573 -612 2 8.9553 10.5154 13.3405 3.89898 -1.19123 3.66799 -613 1 13.0685 1.50992 13.279 -14.1832 25.7313 -25.8855 -614 2 13.6244 1.50815 12.4613 -6.9447 -4.36872 19.5281 -615 2 12.4297 2.25673 13.1075 20.3356 -25.0236 11.2619 -616 1 6.62047 13.6375 2.07221 -5.18984 1.0977 1.00923 -617 2 6.01355 14.0796 2.67998 -4.17105 4.32933 -3.39809 -618 2 7.10668 13.0566 2.65885 8.90022 -6.51269 2.26225 -619 1 15.8066 6.3469 12.5124 13.7748 11.2213 20.1038 -620 2 16.2844 6.87459 11.8544 0.57451 -1.64399 2.92177 -621 2 16.2805 6.52872 13.3684 -12.0243 -5.9969 -18.7155 -622 1 16.7622 0.649503 9.5351 11.3629 -0.534141 16.2257 -623 2 16.8233 18.3334 9.63984 -7.20854 -2.096 2.62458 -624 2 16.3504 0.825019 8.69009 -8.20455 0.909068 -17.3039 -625 1 6.16155 11.6721 8.23727 11.0478 -14.7079 4.32064 -626 2 5.37204 11.4355 8.7099 -18.5694 3.37101 8.66714 -627 2 6.52549 10.7898 8.06052 6.85938 7.24602 -7.48704 -628 1 2.80718 8.60686 0.397493 -27.1124 -12.7057 -15.0387 -629 2 2.16203 8.12721 18.4284 20.3601 19.9434 23.0266 -630 2 2.28863 9.2379 0.937046 1.66532 -5.5958 -10.4069 -631 1 10.1061 10.2794 6.574 -2.68384 6.39054 8.98367 -632 2 10.587 9.61275 7.07222 2.60765 -6.52577 4.24337 -633 2 10.6348 10.4062 5.77746 -5.53346 0.236498 -3.27199 -634 1 6.84319 15.7735 6.74802 2.92919 -7.52667 3.13791 -635 2 7.22287 16.2754 7.48672 -6.2609 -2.86584 0.474311 -636 2 7.16745 16.2182 5.95944 -1.73758 9.59963 -7.48558 -637 1 6.59004 12.8453 5.92771 5.9232 5.70246 -10.7633 -638 2 6.81648 13.7523 6.14266 -3.08056 9.02497 3.95142 -639 2 6.18071 12.4806 6.71128 -2.95494 -1.85994 5.08984 -640 1 16.7187 12.5557 9.81602 -6.97981 -8.42056 3.44329 -641 2 16.7367 11.9049 9.10465 3.04519 -4.31121 0.702836 -642 2 17.0063 13.3635 9.40922 2.88649 12.8114 -1.84814 -643 1 6.30344 2.78963 2.73877 -9.04367 -13.9111 -2.70816 -644 2 6.4136 3.72217 2.50807 2.58545 1.58307 -3.30667 -645 2 5.8765 2.3355 1.98292 3.38351 11.0448 5.4768 -646 1 10.696 2.92954 3.25253 -4.78239 0.546409 -3.48797 -647 2 10.285 3.77274 3.47459 -3.26512 -0.523652 -3.33277 -648 2 10.2907 2.61783 2.41902 1.90367 1.74508 6.25714 -ITEM: TIMESTEP -100 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.7952 6.55188 17.82 -14.0925 -19.7636 -3.75378 -2 2 7.88023 6.44026 18.1695 19.5523 6.07432 -5.80163 -3 2 8.99571 5.7855 17.2401 -2.64216 11.7935 9.74201 -4 1 0.13387 8.39658 6.71777 11.0686 -17.0219 51.8315 -5 2 0.297964 8.15416 5.82611 3.65759 -8.78146 -34.4276 -6 2 0.663997 7.73523 7.26654 -21.1289 27.238 -19.6589 -7 1 8.71966 0.469223 7.04147 6.63626 1.40123 -3.67752 -8 2 9.62406 0.435013 6.6778 -11.0722 1.83914 2.93454 -9 2 8.2146 0.970711 6.38506 4.19741 -2.20649 2.49068 -10 1 6.44826 1.6863 11.7796 22.1018 -16.0737 -10.0998 -11 2 5.81214 2.23354 12.2013 -20.9633 15.3476 12.0772 -12 2 6.02072 0.836228 11.6256 -4.8988 -3.15305 -3.34718 -13 1 6.89097 5.45035 2.38694 -14.0878 18.1315 0.804401 -14 2 6.23022 6.01625 2.92115 27.2653 -21.4077 -23.7527 -15 2 6.91491 5.77412 1.45583 -9.40281 2.39732 25.4334 -16 1 16.2334 10.2315 16.0664 1.22095 -12.8583 -8.35396 -17 2 17.1105 10.2758 15.679 0.521344 2.88453 0.293596 -18 2 15.9464 11.1361 16.1778 -3.48259 10.2735 3.78324 -19 1 10.8573 15.0007 2.35193 -8.17785 -20.274 -7.01899 -20 2 10.8024 14.5151 3.19219 -3.98998 0.859093 -1.88791 -21 2 11.3201 15.8014 2.5578 8.92048 16.4226 10.3474 -22 1 17.1726 8.21805 11.024 14.0848 -19.0512 -23.2094 -23 2 16.691 8.91369 11.4632 -8.36385 12.6057 9.94503 -24 2 17.8921 8.64427 10.518 -5.71892 -0.131476 8.97419 -25 1 14.5956 15.9799 16.3132 20.7515 -13.8502 3.42179 -26 2 13.7469 16.3872 16.1713 -21.6627 3.23661 7.28294 -27 2 14.5521 15.3865 17.0935 -1.40849 8.21009 -3.21798 -28 1 12.1509 13.2395 0.573493 6.57205 3.5904 2.72349 -29 2 11.837 13.3986 18.3303 -3.80405 -1.74926 -15.723 -30 2 11.7012 13.9105 1.09717 -2.12612 0.929616 9.94365 -31 1 9.32377 5.48511 3.80515 37.2224 0.919853 24.8976 -32 2 8.88878 5.295 4.65312 -11.8166 2.00864 -7.28102 -33 2 8.70235 5.44743 3.10202 -35.0307 -2.6733 -15.0358 -34 1 1.53449 3.88906 11.5762 -21.4592 42.8438 -26.3691 -35 2 1.39761 4.77552 11.9865 7.05639 -9.88004 -9.22537 -36 2 1.89707 3.34621 12.2331 21.1403 -27.4328 37.6181 -37 1 2.11621 6.94729 8.0812 -5.52003 -16.2776 -1.04121 -38 2 2.5746 7.45442 8.7366 8.45236 15.6822 11.2536 -39 2 2.08388 6.07661 8.50513 -4.57751 -6.44388 -7.47435 -40 1 5.24695 4.43578 7.8028 -6.30612 26.2857 -2.69952 -41 2 5.36677 3.49844 7.65426 0.215716 -12.5366 -1.65761 -42 2 4.56392 4.76953 7.18377 10.1949 -9.65667 2.91339 -43 1 3.43524 2.88686 17.4376 -21.7675 5.87472 14.6558 -44 2 3.90981 3.17382 16.6701 17.8952 10.4272 -14.0542 -45 2 2.87759 3.6541 17.6984 8.18662 -9.04753 2.1829 -46 1 7.55778 5.57378 6.15352 3.99821 9.40639 19.9011 -47 2 8.12518 6.20749 6.66299 -12.9927 -14.0765 -9.88952 -48 2 6.98227 5.15891 6.82729 7.75312 -1.10557 -10.9113 -49 1 9.77611 7.00478 12.0482 -6.90333 -2.64414 -8.04886 -50 2 10.0224 6.11753 11.7611 0.642082 2.81741 -0.891425 -51 2 9.0843 7.2891 11.4183 2.80801 -0.947675 5.79882 -52 1 14.1423 3.90191 8.16294 -23.6925 4.35767 -24.2753 -53 2 13.5235 4.53411 7.72337 18.2577 -11.8103 7.89417 -54 2 14.4024 4.31063 8.97869 6.95814 7.70003 16.5888 -55 1 4.54437 17.2359 3.8519 4.03565 10.1791 3.31349 -56 2 5.34213 17.7268 4.08304 4.36901 -6.62302 -0.267376 -57 2 4.17051 17.7127 3.09453 -6.96766 -2.87365 4.53203 -58 1 16.1339 16.4921 10.5971 24.4543 -12.0388 -34.7313 -59 2 15.4578 16.6815 11.2098 -23.1752 5.77424 26.3474 -60 2 15.6745 15.9439 9.92709 9.81353 9.26167 7.23238 -61 1 1.98282 4.87023 -0.0102057 11.328 -31.2723 15.691 -62 2 2.56866 5.25094 0.666382 -3.10152 5.14206 -1.69339 -63 2 1.65849 5.5885 18.1127 -8.58794 22.0564 -11.6074 -64 1 11.0975 13.3336 16.4568 21.334 -26.4555 -13.6253 -65 2 10.7319 12.43 16.5661 -7.83355 14.7592 4.38577 -66 2 11.7328 13.1734 15.7328 -3.59268 8.82171 6.12988 -67 1 9.983 10.9188 16.8195 21.8027 -17.9597 14.5818 -68 2 10.5015 10.1139 17.0687 -12.258 16.9146 -11.8156 -69 2 9.08607 10.6082 16.6912 -8.94921 1.38614 -3.26281 -70 1 11.9148 17.5563 13.4787 -11.9158 -12.5975 -1.23623 -71 2 12.5676 17.2101 12.8515 -0.0246338 2.67811 4.16536 -72 2 12.0003 18.5089 13.4756 8.75914 10.3848 -3.31648 -73 1 6.43245 9.54572 12.2957 1.63429 -3.34072 -14.2423 -74 2 7.08046 9.15867 11.6656 -10.0512 7.63496 6.98562 -75 2 6.90317 10.1892 12.8448 2.76093 -9.73394 -7.4892 -76 1 16.2985 12.7819 2.78073 -6.76278 9.02259 -0.251856 -77 2 17.1507 13.1937 2.56739 -3.11425 -2.92719 1.79117 -78 2 15.6658 13.5347 2.78258 7.1706 -12.5209 -0.796151 -79 1 0.705375 12.7757 5.80641 -31.4327 0.785322 -26.0818 -80 2 0.964058 12.7408 4.86595 9.86444 -3.28161 8.94612 -81 2 18.3663 12.6813 5.72517 19.7421 -2.33124 11.5636 -82 1 5.30386 16.3127 18.466 5.80758 -1.43031 -6.37222 -83 2 5.80257 15.6526 17.9366 -5.42534 13.184 13.7491 -84 2 5.92544 16.7092 0.45256 -3.43112 -6.46136 -2.11967 -85 1 0.781035 7.63768 4.09742 11.023 -5.93732 13.9838 -86 2 0.258202 7.96457 3.37539 -14.755 3.95315 -10.1558 -87 2 1.66078 7.97253 3.8829 3.26007 -0.00880383 4.41534 -88 1 3.24417 9.16605 6.56429 -20.4701 -14.3326 2.83801 -89 2 3.57159 8.65908 7.31953 1.49107 7.58135 -6.52778 -90 2 2.30098 8.88971 6.4655 20.5558 12.7829 2.43715 -91 1 7.26627 10.4004 16.2591 -15.7562 -6.32656 27.9079 -92 2 6.82075 11.2368 16.4586 5.73239 -2.42146 -6.93429 -93 2 6.93167 9.82605 16.9811 6.22417 8.86745 -10.8084 -94 1 10.9892 0.849679 5.07849 4.12027 -5.76689 -13.93 -95 2 11.0513 1.64213 4.53259 0.725375 9.02843 9.39609 -96 2 10.6504 0.238952 4.4041 -0.868918 -3.08012 11.6628 -97 1 4.18223 2.98976 13.1617 1.80285 -9.79496 -4.9743 -98 2 4.46754 3.28562 14.0477 -4.0491 -7.36491 -7.89898 -99 2 4.03841 2.01285 13.1683 3.67857 16.3758 11.7633 -100 1 8.4888 10.2856 1.85141 10.3375 -10.6918 -8.28538 -101 2 8.43451 10.9691 2.52904 -3.58901 -0.686288 7.94652 -102 2 8.82874 9.48425 2.29142 -6.1923 10.8646 1.43904 -103 1 10.2336 1.64305 15.4458 -13.2429 9.10796 4.38269 -104 2 11.1732 1.63861 15.572 16.9305 -2.55664 -1.17381 -105 2 10.0536 2.05804 14.5895 6.55462 -3.46994 -1.37038 -106 1 2.58993 12.7242 7.97336 -7.23425 -8.94691 3.8681 -107 2 3.01571 13.5704 7.82234 5.57764 5.06786 -6.45979 -108 2 1.98486 12.5774 7.23174 0.806159 4.05811 0.362671 -109 1 3.90685 11.8307 5.02738 -19.955 -7.05304 -0.3571 -110 2 3.70751 11.1281 5.68153 3.09094 12.242 -8.4391 -111 2 3.06715 12.0092 4.53628 19.8771 -7.15241 7.2697 -112 1 6.7679 14.5791 16.9276 2.77817 -6.983 11.0716 -113 2 7.71708 14.7379 16.9268 0.980214 1.28706 0.809355 -114 2 6.44853 14.8723 16.076 -0.709014 -5.22289 -12.1565 -115 1 14.1752 14.508 3.1348 7.33594 -12.7834 -7.22412 -116 2 13.6105 15.2801 3.10139 -3.55206 9.35654 4.80996 -117 2 13.7682 13.8754 3.73922 -4.33905 3.15851 6.00261 -118 1 8.77346 18.0937 16.1268 -49.3086 -19.2657 7.09896 -119 2 9.29148 17.2891 16.2682 10.0054 9.31596 -1.94744 -120 2 9.22615 0.228463 15.833 27.8858 8.66202 -5.29688 -121 1 4.63977 1.75161 4.89947 12.6555 12.3233 -26.7382 -122 2 3.82082 2.25711 4.97207 0.159842 -3.07614 2.23584 -123 2 5.05477 2.09313 4.05862 -7.26402 -10.6651 28.8422 -124 1 15.0293 12.6717 16.5117 -23.31 -0.861404 35.6256 -125 2 14.4426 12.7177 17.3057 24.815 2.28331 -11.4604 -126 2 14.393 12.496 15.8301 -9.60755 -0.359254 -28.8722 -127 1 15.7282 18.4115 16.8424 17.2085 30.6847 -2.58542 -128 2 16.585 18.5255 17.3163 -17.0651 -10.3906 -2.34083 -129 2 15.5073 17.4884 16.7844 1.64687 -19.4864 2.05956 -130 1 1.3653 1.32145 16.674 4.57571 12.7751 22.4809 -131 2 2.22966 1.72757 16.8986 -13.3853 -7.67206 -8.47788 -132 2 0.843747 1.53379 17.4789 2.23908 -6.3926 -16.4011 -133 1 18.2502 4.28823 15.9426 5.59379 -7.24598 -18.3859 -134 2 17.8025 3.49471 15.6029 3.53909 11.4984 4.55434 -135 2 0.380345 4.42598 15.3659 -10.3938 -1.91133 11.4 -136 1 12.0179 17.0993 16.1449 -24.7595 -29.8482 27.6473 -137 2 11.2904 16.5264 16.5371 30.7476 29.6052 -3.96723 -138 2 11.7854 17.0696 15.2267 4.30162 8.23296 -25.5613 -139 1 16.0455 2.77586 18.2041 10.6955 -6.31261 -1.53201 -140 2 15.9135 3.65525 18.5895 -10.0784 -5.09061 -10.2232 -141 2 15.7148 2.7749 17.2908 -2.70848 4.2718 2.75475 -142 1 6.57887 13.7167 10.0128 0.388305 24.4332 24.1101 -143 2 6.2636 13.3347 10.8463 6.37938 -3.40375 -0.55213 -144 2 6.43171 13.0818 9.3305 3.17506 -19.669 -12.997 -145 1 10.1062 18.565 2.71626 12.0596 2.32822 -17.6158 -146 2 10.7563 0.294125 2.0815 -9.9929 -7.47975 8.60443 -147 2 9.2984 18.4331 2.20633 -1.12272 -0.999648 5.59115 -148 1 3.10044 17.6571 6.21769 -0.590198 -1.20238 18.0356 -149 2 2.16339 17.7471 5.9649 14.558 -0.242179 -11.811 -150 2 3.6505 17.6877 5.42436 -8.00238 0.252249 -9.63341 -151 1 12.5899 16.7797 7.85568 11.434 -9.28582 -14.859 -152 2 11.8995 16.1049 7.73478 -4.76829 8.38316 1.604 -153 2 12.3367 17.3735 8.55676 -7.89443 8.69289 16.0625 -154 1 14.8958 15.3252 8.42405 -10.9907 16.0866 -10.412 -155 2 14.2257 15.9607 8.05927 9.60746 -16.915 15.6813 -156 2 15.568 15.2992 7.73812 1.83068 -0.846784 -8.90808 -157 1 17.9236 18.2959 0.16927 -20.6229 -20.5305 -14.2597 -158 2 18.7101 17.7336 18.8116 8.98564 4.8691 -3.01699 -159 2 18.0908 0.428516 0.675884 12.0916 17.8267 11.1415 -160 1 0.800533 10.4853 1.48213 -15.9305 -52.1134 32.1201 -161 2 0.0210499 9.87138 1.72712 35.348 27.3948 -12.4938 -162 2 0.488783 11.092 0.839839 -12.4886 25.7711 -24.5144 -163 1 1.85398 12.3107 3.26054 -2.39029 3.71051 2.5874 -164 2 1.61156 11.5651 2.68837 -2.80207 3.45241 0.205878 -165 2 2.01622 13.0664 2.66785 -2.08994 -5.59574 4.32216 -166 1 0.726068 17.2941 4.97534 23.1964 8.93599 -27.6283 -167 2 -0.00504426 17.9045 4.96895 -11.3657 3.83105 9.40925 -168 2 0.6848 16.6356 5.64734 -16.8394 -17.6158 22.5419 -169 1 0.979774 0.931094 9.39103 18.34 6.67236 9.68687 -170 2 1.13606 0.587208 10.3041 -6.25966 0.627701 -15.4141 -171 2 0.222638 0.493139 9.00427 -6.20505 -6.29115 6.11619 -172 1 16.8132 2.44689 13.4524 12.1018 18.2567 -5.29927 -173 2 16.9941 2.74318 12.5312 -5.60486 -9.11594 12.8952 -174 2 16.5475 1.52939 13.4414 -4.39811 -15.2301 -8.28386 -175 1 2.68823 16.0572 12.0971 4.35106 -7.5731 1.60029 -176 2 3.00862 15.6347 12.9147 -3.00711 3.68751 -12.4652 -177 2 3.25289 15.7623 11.3532 -3.53001 -2.50035 7.7005 -178 1 16.365 15.3972 6.07793 1.10786 -2.726 6.22736 -179 2 17.2616 15.5854 6.39959 0.338369 -3.43469 -2.74975 -180 2 16.1217 16.1306 5.49548 2.77772 2.55878 -2.13745 -181 1 5.71885 5.23685 11.7571 -1.38587 -22.0348 -7.59079 -182 2 5.34065 5.94353 12.2818 1.95161 11.9795 4.35233 -183 2 5.13977 4.47517 11.9216 1.17844 4.76848 -1.31072 -184 1 15.1029 4.9502 0.771222 1.99697 3.13949 16.3358 -185 2 15.0181 4.74755 1.72068 1.03511 -0.706475 -1.64751 -186 2 14.2572 5.32925 0.539529 -7.17443 2.24029 -6.36177 -187 1 16.4241 16.5209 1.77175 11.7834 22.2537 -31.9797 -188 2 16.1353 16.901 2.59837 -3.82757 4.70614 16.3909 -189 2 16.7243 17.3043 1.2165 -7.10171 -29.7856 17.5505 -190 1 0.166785 4.90105 4.02875 -9.807 6.14851 -6.2016 -191 2 0.490919 5.80972 4.19933 1.47178 -10.2493 -2.87817 -192 2 0.85797 4.25703 4.16889 13.481 4.94217 6.1798 -193 1 2.95388 15.1092 15.162 10.7369 -8.35154 -8.83455 -194 2 2.79081 14.8128 16.074 0.0767364 3.70074 1.09557 -195 2 2.55949 15.9866 15.0864 -8.26758 5.41964 7.36053 -196 1 1.08589 14.7081 9.5149 24.8711 -1.95174 9.92838 -197 2 2.02655 14.926 9.73253 -22.6422 -7.57261 -8.5802 -198 2 0.981604 13.769 9.74603 1.17561 7.47496 0.770389 -199 1 13.5787 16.5188 11.5692 -12.2314 13.2219 -8.78769 -200 2 13.3397 17.246 10.9551 -0.181138 -8.24863 9.65793 -201 2 12.9892 15.7954 11.3146 2.83531 -7.80051 -5.41791 -202 1 4.81777 1.55092 0.678258 -26.6156 -3.92273 4.29753 -203 2 4.35705 2.21925 0.160828 3.99581 1.83661 -5.90848 -204 2 4.05187 1.04139 1.04246 22.8613 -3.7169 0.169547 -205 1 1.54475 18.6679 11.892 -7.41525 16.2224 7.56704 -206 2 1.47416 0.586534 12.6867 1.33096 -5.97454 -6.01551 -207 2 1.79005 17.7987 12.209 7.72027 -7.46968 0.191542 -208 1 11.4358 10.1471 4.23265 -10.894 -3.87129 -8.35951 -209 2 11.2613 10.4034 3.31126 9.28636 4.56211 3.82985 -210 2 12.3915 10.0236 4.32197 -4.85978 3.43988 -0.432274 -211 1 8.20336 12.1359 3.88849 -13.0458 16.1374 35.7669 -212 2 8.99874 12.5954 4.16275 16.0075 -1.33649 -14.8839 -213 2 7.69556 12.2697 4.73273 -2.96338 -15.3566 -29.2591 -214 1 14.5957 4.06338 3.37559 11.9385 -4.24509 -11.5663 -215 2 15.1907 4.01381 4.14053 1.35901 4.80596 -1.61984 -216 2 13.7786 4.41816 3.71066 -15.4173 6.10577 6.17301 -217 1 5.71905 1.6749 7.61995 8.80947 6.26404 67.7498 -218 2 5.099 1.08549 8.07836 1.13728 7.44943 0.131268 -219 2 5.55556 1.51371 6.73852 -13.1925 -8.9768 -74.4163 -220 1 17.8986 1.04478 4.82737 2.1754 -1.83476 -0.744307 -221 2 18.4917 1.14925 4.06283 -1.19754 2.46044 8.41233 -222 2 18.3052 1.49477 5.5864 -1.29774 -0.0865267 -3.68542 -223 1 6.84138 9.15652 4.5536 4.1666 1.31036 -3.45285 -224 2 6.90548 9.53593 5.43168 -5.85674 1.32054 6.56912 -225 2 7.76285 8.95875 4.34348 -1.51129 -0.833856 -3.18299 -226 1 2.51554 14.7147 2.08788 -0.0450507 -1.43316 -6.26715 -227 2 3.18184 14.7861 2.78103 3.7873 -1.55841 0.251503 -228 2 3.00277 14.5163 1.27395 -5.30581 6.45149 3.77223 -229 1 17.2192 13.0031 13.0554 -12.0926 -3.19634 4.57291 -230 2 16.3553 13.3969 13.3572 27.3304 0.34804 -8.60607 -231 2 17.7786 13.6982 12.6582 -16.3476 4.90844 7.68697 -232 1 14.8182 10.5634 1.61386 4.26778 13.3748 6.0388 -233 2 15.4677 11.1895 1.9919 -6.32062 -5.48184 -5.48699 -234 2 13.979 11.0422 1.62876 3.88819 -6.35193 -1.63244 -235 1 5.61579 6.74404 4.50101 -16.4591 -25.6922 -2.42498 -236 2 5.98931 7.61359 4.54862 8.72135 21.7956 -0.434523 -237 2 6.18395 6.1944 5.05334 5.89398 3.69136 0.98365 -238 1 7.99723 8.25195 10.2692 14.8304 8.84149 10.0706 -239 2 8.65992 8.88256 9.91656 -9.90097 -8.80766 -1.78449 -240 2 7.59566 7.7759 9.52484 -1.48617 9.19501 4.49734 -241 1 13.4628 18.4324 5.71378 17.6235 1.75148 -9.47684 -242 2 12.708 0.350866 5.56458 -19.7852 7.87128 -2.36248 -243 2 13.2811 17.9777 6.53219 -7.30606 -12.1428 7.93723 -244 1 0.0668655 2.55772 0.44163 -1.64079 -15.5797 1.12414 -245 2 17.7792 2.62308 0.158326 7.01821 10.3157 -4.2768 -246 2 0.560589 3.37114 0.261458 -5.35649 7.7487 -2.70304 -247 1 12.8473 10.8167 9.6749 -29.1069 48.3462 -20.1155 -248 2 11.856 10.995 9.62541 32.1605 -20.6147 5.13184 -249 2 13.0142 9.92242 9.94244 -8.5776 -22.9331 5.75343 -250 1 0.607197 12.3488 11.1216 10.7177 -2.21067 3.69277 -251 2 18.3016 12.4338 11.1296 -15.0263 -0.672926 -5.71109 -252 2 0.887353 12.7089 11.9725 7.71276 -2.01358 -2.19338 -253 1 5.32001 7.36668 13.2938 5.32433 15.1635 7.63099 -254 2 5.70557 8.20602 12.9842 -2.91102 -7.98825 -6.07053 -255 2 5.82609 7.21997 14.1065 -9.96591 -5.08448 1.55341 -256 1 1.1733 6.74916 11.943 -30.749 -23.7015 -12.6924 -257 2 0.265139 7.01822 11.7017 14.0517 -0.957096 2.97943 -258 2 1.61086 7.53614 12.2133 15.6557 23.6476 13.031 -259 1 15.5486 9.75906 12.4999 -0.653644 29.4777 3.96245 -260 2 15.1521 10.5891 12.1135 7.41979 -25.1975 16.8694 -261 2 15.9641 10.0301 13.3422 -9.48671 -5.05259 -12.6364 -262 1 16.5044 12.5382 5.51299 -3.50049 1.7151 -41.7779 -263 2 16.2902 13.4721 5.54585 0.30498 11.7411 21.1442 -264 2 16.3754 12.4207 4.53497 7.77761 -11.637 24.1999 -265 1 6.32544 9.92844 0.21289 -23.4091 -5.64021 -11.1485 -266 2 5.58447 10.3552 0.689761 9.59747 -6.57127 -5.34636 -267 2 7.10511 10.1371 0.71679 14.7949 3.34633 14.2781 -268 1 12.1134 5.97718 4.01208 -22.8865 -14.7559 9.656 -269 2 12.2541 6.73773 3.46345 4.76282 13.7738 -16.8186 -270 2 11.1454 5.80116 3.92348 22.2207 -1.187 3.16864 -271 1 0.310021 12.9061 0.00438974 -4.95288 1.79463 -7.14095 -272 2 18.578 13.473 0.695812 6.768 -1.51286 0.947724 -273 2 18.4929 13.1888 17.8371 0.864006 -6.25549 9.7975 -274 1 3.57649 0.0893425 8.67318 10.7138 1.44606 -23.5182 -275 2 3.53585 18.3471 7.78602 0.204258 -6.73647 -0.0210952 -276 2 2.75019 0.556646 8.71194 -17.5671 6.50862 13.0872 -277 1 7.32229 17.553 4.46711 -1.8346 22.7033 -6.51397 -278 2 7.49747 18.5341 4.60164 1.92735 -36.6431 -12.1684 -279 2 7.43093 17.3591 3.50845 0.44318 8.65947 16.4016 -280 1 9.23372 17.1692 12.2368 -1.40541 18.7929 10.7586 -281 2 9.17923 16.5713 11.4947 6.54031 -16.824 -6.24154 -282 2 10.1445 17.1937 12.5849 -6.50468 -4.83213 -2.69749 -283 1 13.3883 13.1392 7.89062 -8.44361 -29.718 12.0449 -284 2 13.2983 12.3346 8.48336 5.26587 25.8846 -16.8323 -285 2 14.1176 13.673 8.22732 -1.02664 3.48474 5.19869 -286 1 14.8313 2.83639 15.4549 13.5448 -0.0778016 6.35676 -287 2 14.1767 2.18003 15.2177 -4.87233 -8.03631 -4.89691 -288 2 15.4971 2.82305 14.7488 -5.52573 3.83225 -1.21536 -289 1 9.88985 15.6498 16.9162 -1.5178 12.6863 -12.8881 -290 2 10.4068 14.8878 16.6522 -4.3383 -15.6303 0.424585 -291 2 9.57752 15.4658 17.7984 -6.29913 -5.39682 13.2163 -292 1 11.1832 8.45041 16.604 0.69795 7.62392 -5.91094 -293 2 10.4558 7.91494 16.2714 -2.08228 -2.22425 -3.83894 -294 2 11.7364 7.86183 17.1086 3.16052 -9.92137 8.33691 -295 1 3.98058 18.2281 16.8796 4.69725 -6.17709 8.80305 -296 2 4.47544 17.5796 17.4031 -3.04366 -6.21568 -3.2578 -297 2 4.2975 0.415113 17.2284 -3.71051 8.24157 -1.82763 -298 1 2.31186 4.29334 8.90298 15.9673 -19.5394 32.2139 -299 2 3.25638 4.01729 8.88792 -18.4415 10.5974 -6.3491 -300 2 2.00846 3.99585 9.80326 5.50039 13.6474 -24.2252 -301 1 9.93626 10.4071 9.85717 -7.16433 6.26663 -15.7674 -302 2 9.36967 11.1624 9.60099 8.89086 -7.49456 6.1891 -303 2 10.0442 10.3828 10.8072 -0.648607 3.91668 13.0823 -304 1 9.8312 0.910661 10.8223 11.6198 7.73817 -5.63486 -305 2 9.46664 0.0599513 11.0613 -12.5627 -8.03565 7.40448 -306 2 9.23233 1.33675 10.1908 -3.5905 -1.89286 -1.84539 -307 1 9.13587 15.2239 10.1542 8.27875 -9.17261 13.8125 -308 2 8.75897 15.8188 9.50902 -6.94043 7.83547 -6.48358 -309 2 8.46187 14.5466 10.3059 -2.40816 2.69742 -4.7236 -310 1 0.685213 9.67274 10.114 -7.63752 22.5158 18.5003 -311 2 0.719625 10.5209 10.6443 4.69174 -21.4783 -21.4849 -312 2 1.56632 9.47392 9.79675 4.15873 2.44002 -0.184199 -313 1 17.1428 4.74332 7.9842 -7.49261 0.0436566 15.7002 -314 2 16.4923 5.43036 8.24486 9.33931 -9.59151 -5.74994 -315 2 17.1543 4.09081 8.70481 -1.62938 8.73821 -5.69634 -316 1 14.873 14.5838 0.184633 -12.5055 -0.863041 8.47648 -317 2 15.4452 15.0773 0.785336 2.49238 5.2379 -3.7088 -318 2 14.1221 14.3325 0.749692 6.56524 -1.80757 -8.31994 -319 1 3.93739 11.0893 9.63941 -1.02455 -14.3236 -20.6383 -320 2 3.83455 11.1931 10.5803 -4.40039 8.60569 15.1914 -321 2 3.22961 11.5882 9.19534 2.92088 3.20496 1.27781 -322 1 11.4787 10.7372 1.42758 24.3197 -0.772389 9.7934 -323 2 11.803 11.5915 1.09275 -4.97826 -3.71445 3.9898 -324 2 10.5984 10.6629 1.1011 -26.1902 -1.18673 -8.43185 -325 1 13.1873 7.21634 12.6041 -15.1781 -16.7535 7.59792 -326 2 14.1321 7.04558 12.6338 7.66113 -4.04391 -1.22332 -327 2 12.7625 6.33802 12.7657 6.99529 16.5731 -3.03327 -328 1 9.70202 2.01155 0.798053 14.7354 3.6785 18.4689 -329 2 8.80874 1.78739 0.563168 -12.7542 -2.84597 -8.5823 -330 2 10.1462 2.35336 0.0231027 2.1886 1.53799 -6.67264 -331 1 10.5601 13.4177 4.61479 15.5689 5.45852 21.4774 -332 2 11.4398 12.9929 4.68798 -8.71776 0.745444 -2.53542 -333 2 10.4627 13.8549 5.48714 -1.1208 -2.16649 -13.1077 -334 1 14.6135 1.64587 10.9888 -15.9483 2.47769 1.03658 -335 2 15.3653 1.14828 10.6398 3.3395 9.35485 -7.37665 -336 2 14.6055 2.55489 10.6162 9.33106 -12.1869 7.67578 -337 1 14.4205 12.072 11.5247 -14.0438 -11.3661 -21.2086 -338 2 15.2325 12.1783 11.0185 5.83651 11.9615 0.736203 -339 2 13.7775 11.7491 10.8405 12.2041 8.47933 23.407 -340 1 8.16075 5.17074 9.91542 -32.2508 22.4833 15.2463 -341 2 7.26447 5.43351 10.2769 29.6925 -9.34554 -9.10024 -342 2 8.08912 4.23235 9.75273 2.68018 -15.2376 -3.85437 -343 1 1.73754 17.0197 18.4251 17.7604 24.8388 -20.6387 -344 2 2.31535 17.5448 17.7835 -20.2636 -19.608 22.2942 -345 2 1.91865 16.0976 18.2314 3.71033 -9.13614 -1.37747 -346 1 1.38218 17.4352 15.3141 25.6123 -1.10879 -8.05345 -347 2 1.40837 18.2867 15.7687 -7.1514 0.273564 3.63966 -348 2 0.483975 17.1212 15.2601 -14.2857 -2.70278 3.05549 -349 1 3.46713 5.71669 6.03858 -5.21329 -0.208659 9.269 -350 2 3.09179 6.35885 6.66621 -4.29108 -6.04245 -5.71481 -351 2 3.94628 6.22951 5.39233 13.1871 8.33197 -8.25473 -352 1 12.7108 9.52885 14.2713 4.43437 -19.6411 -8.16456 -353 2 13.1132 8.73466 13.871 -3.04318 14.9787 -8.97539 -354 2 12.4252 9.15135 15.1011 -11.0135 5.38653 13.5706 -355 1 4.12803 15.1962 7.19495 12.4066 -8.66704 -3.75127 -356 2 3.59847 15.8823 6.77325 5.03517 9.17322 -2.57748 -357 2 5.08076 15.3227 6.96437 -18.0652 5.77836 0.725546 -358 1 0.842345 8.89099 15.1297 2.31502 -25.1166 0.479797 -359 2 0.506769 9.78853 15.0967 4.66165 8.13805 -4.97691 -360 2 1.56169 8.8202 14.4757 -4.5077 5.49756 1.76436 -361 1 12.9722 8.22706 10.1223 30.4908 -35.0116 2.62512 -362 2 13.7358 7.69898 9.75664 -18.6412 19.8455 -0.140907 -363 2 12.9154 7.83668 11.013 -6.3959 11.2287 -1.2259 -364 1 15.209 8.0796 3.38747 1.18456 -35.8933 6.76248 -365 2 14.5518 7.57266 2.91157 -10.3511 16.9608 -18.4151 -366 2 15.3784 7.42989 4.0872 14.9983 19.582 11.3682 -367 1 17.1108 6.70081 18.626 -14.4882 23.5427 -0.564853 -368 2 16.573 5.93167 0.182006 3.19594 -3.93797 2.70551 -369 2 16.4292 7.40436 18.4932 17.3888 -11.7094 -2.73385 -370 1 8.93374 7.05508 7.97597 -34.6157 -22.4872 9.48373 -371 2 9.83531 7.32727 7.97774 29.5921 7.62374 2.22252 -372 2 8.80811 6.41093 8.72029 6.54491 10.6746 -16.3243 -373 1 12.5312 0.423333 1.1911 6.44852 -9.8202 9.01884 -374 2 13.2753 0.834119 1.64897 1.63592 5.99122 -1.78887 -375 2 12.9315 0.0607692 0.396252 -6.77848 2.89528 -3.69601 -376 1 5.75537 14.98 14.4363 12.3645 2.0371 -4.21343 -377 2 4.82148 15.0687 14.6213 -16.3449 4.01416 5.01671 -378 2 6.0882 15.8478 14.162 -3.83146 3.10822 0.706071 -379 1 3.69037 6.49544 1.72037 -3.07239 6.81288 -7.41536 -380 2 3.43088 7.36249 1.36332 1.27628 -12.1507 -2.18765 -381 2 3.67848 6.67228 2.6574 4.23334 -3.71069 10.2966 -382 1 3.82256 11.2843 12.3046 -0.864415 -4.77059 0.0245619 -383 2 4.71622 11.5939 12.5181 -0.579536 5.4381 2.57712 -384 2 3.18979 11.9063 12.6819 -0.230908 7.2683 5.57723 -385 1 5.33149 3.8717 15.6726 -21.611 69.2317 6.1195 -386 2 6.02506 3.28248 15.4947 35.9646 -33.3333 -4.61122 -387 2 5.75271 4.79171 15.6869 -18.1046 -35.0984 -1.75377 -388 1 13.9893 10.0773 4.7789 22.4286 4.91544 -48.853 -389 2 14.2819 9.66907 5.58109 5.23319 -9.97863 19.9681 -390 2 14.5573 9.69868 4.0468 -17.0356 6.64649 24.2901 -391 1 7.62039 17.28 9.03644 -1.79817 -13.3385 2.54351 -392 2 6.82618 17.452 9.57294 2.68689 7.94648 -2.92213 -393 2 7.87136 18.0666 8.53956 -0.560867 8.99315 -4.02364 -394 1 4.58082 14.4709 3.89205 3.13293 1.46958 -13.0867 -395 2 4.66344 15.3386 4.31009 -0.0981131 -0.860678 2.59791 -396 2 4.56838 13.761 4.54421 -0.137719 -0.424919 8.72805 -397 1 14.11 7.4138 15.8858 20.156 9.8447 -1.08692 -398 2 14.9007 7.50898 15.3123 -12.2349 -4.78906 9.9244 -399 2 14.35 7.89712 16.7003 -4.15301 -9.39138 -6.29924 -400 1 2.88871 18.3931 1.90601 -10.0733 25.2579 5.70796 -401 2 2.56074 17.6209 1.45485 -4.97176 -8.65563 -11.6917 -402 2 2.08224 0.29716 2.10455 27.8478 -15.7521 2.2348 -403 1 8.03506 1.57584 4.43091 11.32 6.26446 5.75526 -404 2 7.34029 2.01323 3.92479 3.96785 0.109851 -4.32136 -405 2 8.88243 1.87946 4.04557 -12.5027 -7.48646 4.71123 -406 1 2.59748 14.2159 17.7933 -41.9258 1.66076 -8.0641 -407 2 1.85609 13.5734 17.9588 19.2075 16.8599 2.55802 -408 2 3.39352 13.7425 17.9784 23.6145 -16.2032 6.42715 -409 1 1.02442 1.99672 13.9281 17.4639 2.95853 -13.5386 -410 2 1.00308 1.87917 14.8709 4.63864 -6.80727 18.6653 -411 2 18.7659 2.1043 13.6716 -21.6962 3.88026 -3.66909 -412 1 4.27686 0.20187 13.9044 10.5162 4.04171 -16.044 -413 2 5.10447 18.3372 13.9403 -4.05013 6.4475 2.1433 -414 2 3.72354 18.5099 14.5979 -6.57077 -5.71295 14.511 -415 1 7.38305 1.01959 18.4815 -37.4449 7.12948 8.58409 -416 2 7.61008 0.74545 17.6036 5.58611 -6.30497 -21.5445 -417 2 6.41018 1.26146 18.4662 31.347 -10.6343 7.25927 -418 1 15.7518 18.4403 13.8831 -5.31168 6.41878 -7.08883 -419 2 14.7988 18.525 13.6912 13.3949 -2.54728 9.28792 -420 2 15.9153 18.5927 14.8217 -8.96218 -2.42265 4.9219 -421 1 10.3004 4.59906 16.2125 -26.9192 -42.5531 9.44494 -422 2 11.2318 4.75068 16.1287 26.1471 2.80018 1.93501 -423 2 10.2211 3.60629 16.3773 -0.864587 37.9812 -10.9337 -424 1 15.8848 17.7109 4.47524 -26.0192 -17.7161 -6.69824 -425 2 16.416 18.4558 4.72522 12.9982 18.1701 2.23702 -426 2 14.9575 17.9834 4.62838 14.848 -2.41832 2.25768 -427 1 6.86545 17.6577 14.0262 -6.12412 -8.41921 6.45462 -428 2 7.47866 17.6693 14.7646 2.09746 6.93436 13.8689 -429 2 7.44902 17.4838 13.2997 11.4214 -0.145135 -19.8537 -430 1 13.1703 6.41318 6.52816 -11.7529 -0.316938 -15.1514 -431 2 13.9829 6.90375 6.37155 7.88734 -3.14145 2.99861 -432 2 12.7537 6.33512 5.64174 6.34445 -4.78434 12.9923 -433 1 7.85335 2.30114 9.49646 -14.1039 1.33546 -28.6309 -434 2 7.23443 2.06415 10.1901 -3.07143 2.26257 12.1486 -435 2 7.33833 2.15664 8.66054 15.7097 0.546065 18.7565 -436 1 15.1664 14.7315 13.8676 -13.4222 3.7476 -0.777794 -437 2 14.8716 15.1233 14.7167 4.70885 -6.20173 -11.3706 -438 2 14.4912 14.9291 13.1959 7.90291 2.0321 9.20294 -439 1 9.36434 8.4507 3.85153 -5.45323 -8.44175 -9.3174 -440 2 10.195 8.80526 4.18009 6.07261 4.07641 1.89943 -441 2 9.48655 7.50041 3.73575 1.17631 -1.18483 4.07146 -442 1 17.585 13.5529 16.4533 28.0827 9.29223 -15.0932 -443 2 16.6463 13.3857 16.5308 -13.0105 5.34146 -4.98563 -444 2 17.7372 14.3421 15.8749 -12.9185 -11.1551 11.5131 -445 1 5.00344 10.4544 2.83444 15.3623 2.39709 8.30796 -446 2 5.84337 10.0047 3.04968 -12.8086 4.14038 -0.288119 -447 2 4.84487 11.029 3.60723 -3.54173 -2.25206 -8.41364 -448 1 3.64071 8.37653 9.83285 -3.63557 -2.42467 19.3481 -449 2 3.86873 9.30617 9.70655 -0.364806 7.27712 -2.43853 -450 2 3.42279 8.30417 10.789 5.82381 -0.771913 -15.5307 -451 1 16.012 6.92262 5.85834 3.10414 -0.205141 -1.95775 -452 2 16.7064 7.38617 6.35888 -2.44937 -6.94247 -7.87698 -453 2 16.3342 6.01666 5.66219 -6.01431 14.0457 5.91674 -454 1 15.3573 7.28861 8.91428 -7.73552 23.9623 -29.5509 -455 2 15.9286 7.60908 9.59449 17.6585 1.69923 20.6432 -456 2 15.3281 8.05346 8.27817 -7.4668 -29.0722 12.6462 -457 1 6.23444 12.7891 12.7562 -16.1216 7.07791 -6.67583 -458 2 7.04381 12.3675 13.028 12.7717 -9.63916 7.37694 -459 2 6.08648 13.5082 13.3891 2.20208 -1.21591 -2.77254 -460 1 12.1275 4.60499 13.1618 30.5736 27.4894 8.79026 -461 2 12.1815 4.60813 14.1323 1.45244 -2.14521 -6.91324 -462 2 11.4269 4.052 12.8891 -30.6572 -22.7655 -2.33684 -463 1 11.4418 8.05897 7.8749 4.39649 -6.11408 4.26725 -464 2 12.0054 7.38105 7.40707 -4.89778 19.9996 19.2901 -465 2 11.7913 8.23063 8.79017 -1.61454 -12.0828 -25.9053 -466 1 16.8934 10.7552 7.64898 5.958 -15.487 6.46706 -467 2 17.5218 10.034 7.45777 0.434714 4.65833 3.39608 -468 2 16.8005 11.223 6.82193 -0.787623 15.1873 -12.5781 -469 1 5.19162 18.0101 10.6182 -11.7475 -9.51575 -5.50364 -470 2 4.6689 17.2843 11.0141 12.267 13.7571 -4.22389 -471 2 4.61649 18.3258 9.88348 13.0529 -7.1725 20.3587 -472 1 7.61953 17.4141 1.49962 -5.28373 3.7131 11.8258 -473 2 8.17503 16.7132 1.19553 7.57367 -21.9054 -5.9523 -474 2 7.57614 18.0024 0.755384 -3.403 20.0604 -6.05803 -475 1 1.93154 12.9424 13.6297 4.26026 1.62766 0.165619 -476 2 1.31807 12.4855 14.2164 3.08324 -4.19991 0.575461 -477 2 2.34989 13.6289 14.1741 -4.48691 2.36366 -2.57882 -478 1 9.34851 6.7636 14.8211 -2.90069 2.43692 -15.7898 -479 2 9.659 5.88476 15.1078 3.08688 5.56829 -7.87962 -480 2 9.50722 6.89182 13.8456 0.484936 -6.74561 22.7152 -481 1 15.2631 4.37275 10.7209 -0.391742 -1.67154 5.71992 -482 2 16.1506 4.03655 10.897 1.37527 -0.677682 -8.66997 -483 2 15.1154 4.97006 11.4686 -2.24536 -2.27818 -6.11794 -484 1 11.4934 6.22632 -0.0241442 -6.06296 -11.7718 -8.66306 -485 2 11.6483 5.30933 -0.309107 4.27028 6.28431 2.83608 -486 2 10.5284 6.3165 18.5406 6.28072 6.83613 2.73886 -487 1 18.4725 11.4275 14.8977 -1.36673 1.10287 -33.3787 -488 2 18.0559 11.937 14.1605 1.63397 -11.827 9.6186 -489 2 18.3384 12.0011 15.6307 -5.5196 20.2825 24.8766 -490 1 7.17852 9.29091 7.31266 -12.1778 -5.70725 -5.55247 -491 2 6.76293 8.42612 7.50122 5.49043 12.248 4.67896 -492 2 8.1168 9.11866 7.26453 10.5183 -1.31775 0.108346 -493 1 18.3399 15.3762 12.1294 6.77425 7.85663 0.444206 -494 2 0.624383 15.5788 11.9067 -6.5428 -1.83873 1.38378 -495 2 17.7957 15.9125 11.5264 -1.63248 -5.99386 0.103645 -496 1 16.5386 4.34911 5.2503 -38.2238 -21.0357 51.9327 -497 2 16.6701 3.96728 6.16388 -6.69454 12.6485 -26.055 -498 2 17.3775 4.32019 4.85382 41.1543 5.3392 -22.1831 -499 1 17.7341 3.08223 10.7755 -2.39486 19.3144 10.8573 -500 2 18.6554 3.32717 10.9901 -9.67157 -6.39923 -2.68969 -501 2 17.7406 2.18791 10.4534 3.10102 -17.6187 -9.33289 -502 1 12.3347 18.6584 10.1394 22.1152 -18.6094 -11.1242 -503 2 11.4269 0.285024 10.28 -5.50333 15.1479 5.74269 -504 2 12.9381 0.769801 10.2484 -7.53185 0.18177 2.36971 -505 1 10.4414 9.72052 12.5804 5.49259 18.5488 2.65475 -506 2 11.2372 9.86145 13.1232 -3.33328 -5.81976 -2.33485 -507 2 10.4983 8.8205 12.2639 -0.9125 -13.8337 3.2089 -508 1 0.576047 2.60181 7.2501 -1.65995 13.3288 -12.3458 -509 2 0.268028 3.48996 7.49944 2.28387 -7.91724 -1.96879 -510 2 1.05133 2.26453 8.01425 -2.57801 -1.32252 3.73717 -511 1 0.35756 15.2681 6.96461 -6.18578 -18.242 -64.2832 -512 2 0.656709 14.9904 7.8095 9.46814 -3.47663 35.1726 -513 2 0.533918 14.474 6.37104 -3.56161 26.9089 25.8891 -514 1 17.0554 6.8805 14.912 24.4713 -1.83906 11.5387 -515 2 17.8121 7.50971 14.9246 -13.4777 -6.95308 -2.51376 -516 2 17.3666 6.12061 15.452 -8.01529 8.59931 -8.57008 -517 1 9.11821 12.4896 7.9597 -39.3936 14.7629 -4.46817 -518 2 9.45619 11.6923 7.5591 7.68398 -14.1787 -12.8233 -519 2 8.20522 12.6235 7.56541 34.2702 -5.52337 13.9854 -520 1 1.14934 1.62531 2.7512 -10.6975 -16.4856 11.3042 -521 2 0.557887 1.95566 2.07466 1.95024 15.5996 -8.59751 -522 2 1.5216 2.35039 3.25303 6.14281 9.13632 1.51194 -523 1 4.18801 15.1235 9.83797 -4.3571 13.9944 -8.49019 -524 2 4.15169 15.4364 8.91421 -7.63033 -5.74015 13.5827 -525 2 5.04261 14.6826 9.83518 3.69587 -3.91806 9.7151 -526 1 7.38616 2.29059 14.8987 -4.38475 3.80451 -15.2317 -527 2 7.23636 1.51405 14.3418 -1.55041 0.530275 6.25745 -528 2 7.45512 3.02747 14.2682 8.09838 -6.66607 2.4433 -529 1 18.2954 14.5248 2.13868 21.7335 16.5649 1.154 -530 2 0.530315 14.9412 2.32201 -13.6123 -15.8317 -3.76049 -531 2 17.7186 15.2797 1.96871 -6.10103 1.83177 1.59348 -532 1 10.0818 2.68123 12.8993 0.213282 -13.011 -16.4533 -533 2 9.9804 2.00538 12.1749 2.58274 17.6757 17.7308 -534 2 9.30115 3.24961 12.8455 -1.77409 -0.0668197 -1.90377 -535 1 2.92042 8.79199 13.1038 3.60331 12.5418 -6.85933 -536 2 3.19747 9.71233 12.8787 -2.51528 -19.5049 2.84802 -537 2 3.74925 8.3139 13.2755 -6.12566 -1.47569 1.35688 -538 1 3.2826 8.6043 3.78787 -1.06696 -30.5523 53.3514 -539 2 3.6648 9.24286 3.23576 21.5217 31.7748 -30.2126 -540 2 3.73659 8.75462 4.6619 -18.3855 -4.45548 -24.3241 -541 1 5.99503 7.23605 8.68049 -5.70462 -6.01689 -7.52618 -542 2 5.88732 6.32464 8.37432 -5.09887 -1.13221 5.21957 -543 2 5.15444 7.50455 9.08765 4.58913 -3.02319 1.70333 -544 1 14.8694 1.67632 1.824 4.95495 -3.07302 -21.4612 -545 2 14.923 2.54765 2.20438 -6.9063 6.82762 18.8127 -546 2 15.1986 1.83723 0.92353 -1.55356 -7.84532 7.79991 -547 1 8.71318 14.9586 0.633889 5.3189 4.72704 12.5337 -548 2 9.41548 15.0137 1.3229 -12.9747 -8.59069 -7.21106 -549 2 7.9574 14.4505 1.00218 9.17218 5.81258 0.251254 -550 1 15.3522 1.50057 7.22863 -1.61242 -14.2743 -3.26221 -551 2 14.7819 0.961058 6.63945 7.54361 11.5891 10.8038 -552 2 14.804 2.18796 7.6304 -1.95204 4.928 -5.75504 -553 1 4.88832 12.8638 18.4669 14.1773 6.076 10.5021 -554 2 5.16486 12.9634 0.754115 -2.57074 -3.9589 -10.7447 -555 2 5.64539 13.2163 17.9734 -6.87045 1.01425 -0.872896 -556 1 15.3658 8.71105 18.1022 0.313753 1.99863 -15.4271 -557 2 15.6825 9.25538 17.3367 -2.33671 -6.91366 23.9636 -558 2 15.2177 9.29821 0.21527 -1.89476 6.92048 -0.597105 -559 1 12.0025 3.14868 18.2874 -4.08601 9.85731 -2.22671 -560 2 12.1144 3.11564 0.603374 4.33643 -8.86024 -4.9595 -561 2 12.4653 2.40747 17.863 0.0624807 -1.52737 7.22507 -562 1 13.2135 12.7035 5.12884 9.73413 0.384952 2.90661 -563 2 13.7 11.8654 5.00774 -9.98906 4.00813 0.0328844 -564 2 13.4141 12.9701 6.04548 -3.79483 -4.91087 -6.97232 -565 1 6.18903 7.09371 0.234798 3.60985 -26.8596 -14.0682 -566 2 6.2071 8.04594 18.8061 -7.0012 19.4313 6.00448 -567 2 5.26363 6.79856 0.279731 4.49735 8.94005 5.55961 -568 1 17.7003 15.89 14.853 -18.1963 11.2058 -20.3772 -569 2 16.8346 16.3247 14.8039 6.19322 -4.54728 12.6057 -570 2 17.8435 15.7325 13.9057 13.4875 -6.37623 4.18836 -571 1 13.0834 0.870867 16.8965 -0.161813 1.3846 -1.86612 -572 2 14.0072 0.582211 16.892 1.10768 1.72224 0.871652 -573 2 12.5754 18.726 16.653 1.71204 -0.315799 1.62538 -574 1 10.8945 14.507 7.48359 31.9827 12.7774 -14.5262 -575 2 10.2535 13.8684 7.76101 -18.1255 -14.8352 9.6937 -576 2 11.748 14.0397 7.49435 -7.74827 -1.48019 1.36014 -577 1 17.7521 8.40099 2.11802 -4.68381 10.101 13.2464 -578 2 16.8759 8.32923 2.50971 -7.38706 6.94009 5.95596 -579 2 17.7532 7.67887 1.5098 2.25561 -17.6604 -22.6471 -580 1 12.5231 7.84865 2.0094 -2.30264 15.9804 1.37474 -581 2 12.1379 8.74758 1.97393 9.3167 -10.0751 -1.70323 -582 2 12.325 7.4571 1.14918 -4.66948 -5.90928 2.89896 -583 1 11.972 14.5025 10.3451 -2.96888 12.9379 -2.77484 -584 2 12.1874 14.7132 9.42348 -1.74009 -6.18971 10.5862 -585 2 11.0277 14.706 10.4449 2.87573 -2.36207 -4.30421 -586 1 6.71227 6.84952 15.5806 25.6498 -3.78319 22.6581 -587 2 7.68828 6.90632 15.3859 -23.8939 0.442938 5.1849 -588 2 6.62279 7.02219 16.5478 -0.830995 -1.23763 -22.0679 -589 1 7.92027 4.40739 13.1357 7.88731 17.7005 28.4833 -590 2 7.20639 4.70613 12.563 -5.96959 3.19417 -4.54574 -591 2 8.05118 5.13552 13.7952 -2.84521 -16.8776 -20.7331 -592 1 13.2899 12.2294 14.3537 -3.3223 6.18653 6.3482 -593 2 12.9901 11.3268 14.1873 4.87208 -4.78833 3.90165 -594 2 13.6879 12.5058 13.5223 1.91273 0.0234059 -4.06458 -595 1 14.5389 9.51264 7.32918 -7.01434 -27.1539 -11.6023 -596 2 15.2763 10.0624 7.53312 20.4851 16.6908 8.43718 -597 2 13.8132 9.80854 7.861 -14.3264 8.19434 11.2695 -598 1 12.68 16.8773 3.29092 2.11558 25.6431 -8.94229 -599 2 12.7733 17.3894 4.13219 -1.2803 -9.72294 -18.9636 -600 2 12.6793 17.5234 2.53176 -0.650571 -10.0569 23.6182 -601 1 0.970813 7.05439 17.3478 19.6691 8.71735 -9.44801 -602 2 0.0997442 7.2771 17.6294 -27.888 -7.65058 15.2547 -603 2 1.07493 7.61203 16.5711 5.30897 3.90939 -5.98442 -604 1 13.0218 4.86702 15.7977 -14.5255 -22.5737 -0.430567 -605 2 13.6652 4.12206 15.7771 -2.73243 23.3382 0.768668 -606 2 13.4898 5.70142 15.8866 10.098 7.61534 -0.732483 -607 1 2.35004 3.40025 5.07686 -12.6408 -17.529 -7.45963 -608 2 1.84891 3.15034 5.87751 4.27568 5.0167 -3.29201 -609 2 2.74325 4.26374 5.21682 1.23402 6.29722 12.7184 -610 1 8.14417 10.9001 13.7499 9.28616 -30.1931 45.6744 -611 2 7.9506 10.3552 14.611 8.46781 36.9232 -44.8577 -612 2 9.00813 10.5574 13.4404 -10.6035 2.99953 -2.14266 -613 1 13.0821 1.49083 13.2989 5.3891 9.28887 -24.1834 -614 2 13.7872 1.3627 12.5959 -25.8284 12.5052 17.3021 -615 2 12.4896 2.22352 12.9857 19.0093 -19.6589 8.86348 -616 1 6.62484 13.6674 2.02561 -2.30013 1.61314 -5.1998 -617 2 5.94206 14.1599 2.51404 7.05284 -6.38204 5.2583 -618 2 7.12137 13.1184 2.65568 -4.11309 1.61678 2.96157 -619 1 15.7857 6.33001 12.4874 9.47505 -1.37582 18.5865 -620 2 16.2809 6.76838 11.7933 3.97273 7.7159 -2.96061 -621 2 16.3586 6.41799 13.2831 -12.689 -0.09302 -8.30077 -622 1 16.7471 0.613682 9.52771 11.5447 -14.6629 17.7173 -623 2 16.7567 18.2848 9.57147 -3.7535 4.88819 4.87116 -624 2 16.43 0.840462 8.66213 -13.2327 5.78697 -22.1845 -625 1 6.19152 11.681 8.24955 3.80355 -8.99636 -2.81467 -626 2 5.36879 11.4903 8.73023 3.19436 -10.2741 -4.0588 -627 2 6.55865 10.8405 7.8788 -10.8203 9.76695 14.653 -628 1 2.78766 8.56788 0.409413 -52.7319 2.11899 -11.855 -629 2 2.08185 8.03903 18.552 32.3713 20.2249 14.5342 -630 2 2.26775 9.27739 0.866586 13.6595 -12.5773 -9.56289 -631 1 10.1003 10.2385 6.61376 -10.8952 5.58665 6.62413 -632 2 10.4921 9.47201 7.04387 8.70092 -2.05853 1.95229 -633 2 10.597 10.3787 5.79806 -1.31095 -2.00825 -0.431677 -634 1 6.84539 15.7603 6.76774 -1.32488 -8.5888 0.285168 -635 2 7.15445 16.2386 7.5582 -1.07119 -0.859265 -6.52036 -636 2 7.16186 16.249 5.99512 -0.908646 8.8198 -0.167177 -637 1 6.64088 12.8596 5.99362 6.27305 7.11444 -12.0385 -638 2 6.74407 13.8044 6.07603 1.27228 12.7365 2.69296 -639 2 6.25078 12.5941 6.82297 -5.96354 -7.18103 4.5408 -640 1 16.6867 12.5722 9.84379 -3.64815 -5.06409 7.40683 -641 2 16.7505 11.8965 9.15556 3.82735 1.49832 -4.74998 -642 2 16.8024 13.43 9.4304 0.212763 1.2752 -2.86494 -643 1 6.31521 2.74143 2.73106 -6.87016 -8.03266 -4.4066 -644 2 6.55003 3.64872 2.52358 -0.655364 10.9132 -0.0341781 -645 2 5.98199 2.35933 1.9027 -1.39596 -0.0669143 5.2552 -646 1 10.642 2.89265 3.25205 -8.44131 -1.48195 -5.66324 -647 2 10.1183 3.68518 3.4139 4.92295 3.00907 1.37692 -648 2 10.2968 2.53281 2.41595 2.77965 2.00448 3.56419 diff --git a/examples/amoeba/dump.water_box.amoeba.32.test b/examples/amoeba/dump.water_box.amoeba.32.test deleted file mode 100644 index 9019401850..0000000000 --- a/examples/amoeba/dump.water_box.amoeba.32.test +++ /dev/null @@ -1,7227 +0,0 @@ -ITEM: TIMESTEP -0 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.67966 7.08769 17.9461 -18.0057 -16.954 4.82612 -2 2 7.80945 6.75579 18.2607 19.8034 12.4721 -7.17463 -3 2 8.72223 6.81424 17.0254 7.13784 0.0282027 3.08606 -4 1 18.5257 8.24445 6.83762 8.52147 14.2257 60.5703 -5 2 0.216892 7.89544 6.05003 12.0964 -15.6711 -53.3384 -6 2 0.444268 7.82601 7.5302 -13.3675 6.47926 -9.3119 -7 1 8.37906 18.5504 6.81463 24.6094 6.61103 -1.11969 -8 2 9.34042 0.098069 6.73406 -18.7879 -2.64022 0.747908 -9 2 7.93962 0.573676 6.26984 -2.09268 1.16699 2.67386 -10 1 6.58995 1.84432 11.7198 46.7475 -13.739 -10.5489 -11 2 5.88543 2.40231 11.9251 -37.1346 27.545 16.57 -12 2 6.18153 1.06275 11.3693 -7.36455 -17.4045 -5.52161 -13 1 7.1466 5.75358 2.33152 -53.3657 41.599 -1.38826 -14 2 6.36812 6.12603 2.86268 38.0857 -22.9036 -2.95785 -15 2 7.02502 6.29465 1.5182 16.1101 -20.4591 11.2904 -16 1 16.2164 10.1388 16.1382 -32.9296 19.8915 17.3579 -17 2 16.9509 10.2747 15.5847 32.6569 -1.09677 -20.2087 -18 2 15.8498 11.0405 16.2399 2.59134 -12.8635 2.30838 -19 1 10.6046 15.0374 2.30369 -9.45108 -28.933 -9.95229 -20 2 10.5292 14.3949 3.01849 1.67759 -0.529274 5.48943 -21 2 11.0236 15.78 2.70962 13.2591 21.3673 6.11781 -22 1 17.1624 8.24409 10.3708 10.41 5.9387 11.3227 -23 2 16.5528 8.68798 10.966 -4.81374 9.55532 3.583 -24 2 17.9421 8.82333 10.3208 -3.63548 -8.99367 -3.64514 -25 1 14.901 15.8652 16.3167 21.2892 -10.1645 16.79 -26 2 14.0225 16.1982 16.2525 -30.7371 12.6366 -7.00126 -27 2 14.9141 15.482 17.2099 1.64171 -7.21798 -3.7798 -28 1 12.1752 13.3771 0.408263 -10.449 7.39269 11.8256 -29 2 12.0579 13.8465 18.23 5.34035 -4.48355 -17.1718 -30 2 11.6217 13.8904 1.00796 2.45905 -0.157672 9.39156 -31 1 9.27358 5.34243 4.05546 -29.354 32.8373 13.3322 -32 2 8.64594 5.4665 4.83764 23.9402 -17.6274 -26.2044 -33 2 8.74177 5.68615 3.30282 4.39732 -15.4932 8.77495 -34 1 1.83016 4.27673 11.6495 -22.4867 33.9085 -11.1027 -35 2 1.70328 5.22377 11.9391 5.26663 -24.2909 -6.35354 -36 2 2.40811 3.85345 12.2597 16.6835 -12.3735 20.3319 -37 1 1.96438 6.83299 8.3731 -11.8866 6.09586 -26.8326 -38 2 2.49614 7.21578 9.0563 11.4719 0.0715494 18.6532 -39 2 1.81128 5.90585 8.57354 7.57659 -6.58781 5.32172 -40 1 5.40557 4.38899 7.93274 -5.84675 9.40812 -2.24834 -41 2 5.53738 3.43895 7.78131 -7.95286 9.95376 -0.129754 -42 2 4.75516 4.73491 7.29062 11.2407 -18.5615 7.61563 -43 1 3.23 2.92842 17.5524 1.14755 15.2746 17.0601 -44 2 3.93109 3.19827 16.9402 0.871842 10.3641 0.782189 -45 2 3.00444 3.70897 18.1497 2.9668 -26.2705 -22.3315 -46 1 7.4624 5.26283 6.13117 4.99569 4.7543 -2.87263 -47 2 8.02565 5.58849 6.88177 -21.8117 -10.641 -11.2175 -48 2 6.93508 4.45577 6.3254 15.5754 16.5621 10.3274 -49 1 9.77896 7.02384 11.9834 11.1892 -4.91774 24.9965 -50 2 10.2721 6.37256 11.5011 12.944 -11.2243 -3.64487 -51 2 9.1532 7.31587 11.3499 -25.3515 14.1302 -21.9158 -52 1 14.1167 3.54999 8.03003 -26.7224 -2.96987 -36.9282 -53 2 13.4732 4.22413 7.73132 14.0058 -9.36539 3.16858 -54 2 14.3809 3.80189 8.88487 12.5079 17.7406 36.8421 -55 1 4.82329 17.2568 4.03846 -17.1239 31.8599 -29.451 -56 2 5.49315 17.973 4.01308 -7.2715 -20.7015 10.2799 -57 2 4.18746 17.5412 3.33843 11.1391 -13.8034 10.6312 -58 1 16.4918 16.6259 10.0493 30.7319 18.7558 -40.9431 -59 2 16.1673 16.3226 10.8594 -24.9276 -14.9205 38.9888 -60 2 15.9925 16.2084 9.33562 -5.59472 -4.21747 7.16045 -61 1 1.94489 4.93323 0.49791 29.2037 9.87254 4.22328 -62 2 2.55322 5.26335 1.2053 -16.134 -9.14189 -14.6469 -63 2 2.08253 5.591 18.4408 -15.0883 -1.49688 2.64821 -64 1 11.816 13.3571 16.2711 -9.40148 3.94995 7.41554 -65 2 11.2371 12.6203 16.5671 11.2868 -0.226619 -16.3723 -66 2 12.2446 13.1893 15.4079 -8.93504 -7.51369 10.5349 -67 1 10.105 11.0651 16.9545 19.171 -30.5561 3.11717 -68 2 10.5674 10.1947 17.1295 -13.2328 27.8223 -6.21699 -69 2 9.25349 10.8067 16.5912 -4.96621 2.04172 2.74708 -70 1 11.7264 17.5421 13.4742 -3.04385 -27.7441 -11.1528 -71 2 12.2771 16.9836 12.8968 -5.80236 0.92931 5.24929 -72 2 12.1041 18.3936 13.317 3.92972 25.4072 2.69815 -73 1 6.33029 9.31911 12.2264 14.5686 -26.7823 -24.0739 -74 2 7.02603 8.96242 11.6353 -16.9594 2.64581 0.0898615 -75 2 6.81249 9.95941 12.7172 6.645 23.591 18.9185 -76 1 16.2187 12.7249 2.70186 -8.60429 -40.8729 7.98732 -77 2 17.0292 13.1566 2.50302 21.6794 20.3416 -10.6726 -78 2 15.4982 13.3357 2.61812 -11.4268 23.7847 2.88762 -79 1 0.637202 12.5625 5.84914 -31.8402 8.87564 3.58131 -80 2 0.892312 12.5507 4.90771 -4.9886 -2.92912 11.9697 -81 2 18.3039 12.804 5.85329 37.806 -5.77498 -8.15105 -82 1 5.19922 16.3781 18.5047 -8.79571 2.1563 -13.4584 -83 2 5.80284 15.8543 17.9455 2.86332 8.92403 13.1762 -84 2 5.67034 16.9636 0.462296 7.01287 -6.10758 -1.1835 -85 1 0.510145 7.62945 4.0545 45.1401 15.6351 -20.049 -86 2 18.5719 8.14656 3.45296 8.17292 -14.6601 7.70417 -87 2 1.46496 7.74082 3.66917 -48.4928 -0.554047 23.6518 -88 1 3.14672 8.89584 6.52626 -55.2927 3.32392 -1.46176 -89 2 3.50609 8.59991 7.35294 11.5609 -2.03159 9.82262 -90 2 2.14573 8.92962 6.68203 43.6989 0.357582 -10.1043 -91 1 7.30854 10.3037 16.1717 1.78466 -0.469392 13.5048 -92 2 6.56213 10.4624 15.5802 -0.177974 -0.17468 9.69093 -93 2 6.99303 10.278 17.1118 -1.93161 2.46429 -18.5659 -94 1 11.1122 1.06968 4.98939 -2.5529 -18.3754 16.0671 -95 2 11.0776 1.97142 4.64864 2.28669 -2.46607 -13.2595 -96 2 10.7048 0.433547 4.37027 3.43033 14.549 -3.59534 -97 1 4.45204 2.70061 13.2052 -5.66348 -30.5004 33.0628 -98 2 4.60333 3.05865 14.0914 -1.92534 16.2672 -14.1546 -99 2 4.38645 1.737 13.4626 -0.349226 19.9023 -23.5316 -100 1 8.42792 10.0237 1.78469 -10.3917 -19.899 15.7952 -101 2 8.3405 10.6377 2.53622 4.61332 0.207175 -2.25283 -102 2 8.49672 9.11244 2.17467 4.01989 28.7847 -10.326 -103 1 10.5335 1.75383 15.546 -34.1458 -0.453574 1.15961 -104 2 11.3977 1.82718 15.9216 24.1476 -5.37633 -0.0681618 -105 2 10.5608 1.78317 14.5837 3.50677 3.31298 -0.339701 -106 1 2.77693 12.941 7.74821 -10.4378 -0.583625 -1.53852 -107 2 3.28797 13.5733 7.23382 6.48403 3.62296 3.43855 -108 2 1.98704 12.8256 7.20013 3.29426 -8.64685 -0.0486837 -109 1 3.63517 11.6895 5.33963 -11.8109 -10.1864 -4.68879 -110 2 3.35385 11.0502 6.03137 5.66752 13.6786 -16.6554 -111 2 2.8758 11.855 4.74058 12.1084 -4.04172 11.1294 -112 1 6.88803 14.474 16.8428 -11.4129 11.5698 10.6698 -113 2 7.55973 13.8293 16.6383 5.64016 -3.74285 -2.32739 -114 2 6.60381 14.8838 16.0165 -1.10143 -9.42407 -1.70294 -115 1 14.1722 14.5374 3.41536 22.8916 -3.95473 -24.8295 -116 2 13.6514 15.2845 3.14096 -10.2906 15.0357 0.984662 -117 2 13.8512 14.2508 4.25439 -13.7068 -8.63673 17.9444 -118 1 8.28226 18.1809 16.0824 -12.751 -14.2632 -6.38017 -119 2 8.77677 17.3494 16.3071 3.86396 27.0257 -3.69586 -120 2 8.7603 0.384816 15.9919 13.8336 -15.3184 3.9152 -121 1 4.73724 1.61643 4.90111 4.42093 34.2728 -25.3552 -122 2 3.96969 2.16837 5.15263 7.5353 -10.5013 -8.47368 -123 2 5.18465 2.1484 4.15475 -16.3947 -25.6944 40.0476 -124 1 15.1457 12.8616 16.4403 -17.2871 -9.38827 44.2976 -125 2 14.6041 12.8692 17.2613 20.1997 8.40389 -10.3991 -126 2 14.49 12.6307 15.8136 -19.9308 -5.03226 -40.1466 -127 1 15.779 18.3837 16.786 46.4421 11.1965 42.4368 -128 2 16.5108 18.615 17.4688 -40.0732 -8.23978 -31.409 -129 2 15.7694 17.4186 16.7687 -10.9286 -0.13557 -0.275231 -130 1 1.1383 1.1331 16.5571 -3.78806 10.8903 6.59298 -131 2 1.96551 1.50352 16.9177 -13.4358 3.04324 -1.88802 -132 2 0.420521 1.53444 17.0916 18.9396 -8.74897 -5.5358 -133 1 18.0817 4.5907 15.863 15.5867 -18.8741 -0.0488223 -134 2 18.5818 3.91936 15.3489 -11.2031 15.1049 7.34982 -135 2 18.5602 4.7339 16.6874 -0.349245 -1.77666 -1.18458 -136 1 12.22 16.9378 16.1148 -5.50141 -11.6153 60.0453 -137 2 11.409 16.6934 16.6676 25.9686 4.83442 -31.2532 -138 2 11.9646 17.3216 15.2917 -16.184 2.10738 -25.7541 -139 1 15.8709 2.55221 17.9707 -0.937802 24.4841 -15.6355 -140 2 15.7355 3.48355 18.2574 7.57333 -26.0521 3.95198 -141 2 15.6659 2.59235 17.0072 3.66916 -5.77112 18.206 -142 1 6.70868 13.791 10.2637 2.56639 25.7323 0.00368182 -143 2 6.59347 13.548 11.1958 -0.357243 -4.92282 -5.01928 -144 2 6.58252 13.0514 9.6765 -3.72683 -17.1721 -0.802691 -145 1 10.146 18.2027 2.80372 18.7695 36.9578 -11.0057 -146 2 10.2207 0.331961 2.18345 -3.04248 -21.6078 13.7214 -147 2 9.26571 17.8868 2.67703 -19.5044 -8.44618 -8.21612 -148 1 2.97538 17.748 6.06078 -25.8303 0.797173 6.8887 -149 2 2.09399 17.6473 5.67013 0.763714 -3.05404 12.9421 -150 2 3.45883 17.8838 5.26396 31.3429 0.483929 -10.2997 -151 1 12.558 17.0134 7.97028 5.92903 -16.4499 -7.28316 -152 2 11.9572 16.2512 7.82085 0.921176 10.9238 13.6165 -153 2 12.4657 17.4524 8.83591 -10.9555 -3.32417 -4.29455 -154 1 14.8795 15.2862 8.28544 4.29768 -18.9738 42.4504 -155 2 13.9824 15.6136 8.40666 -1.92729 9.60106 -14.0248 -156 2 15.2312 15.4641 7.43118 3.9302 10.2131 -33.7787 -157 1 17.5429 18.3228 0.375372 -51.2916 -3.32975 -15.7386 -158 2 18.116 17.6308 0.128652 39.2354 -21.6017 -8.51882 -159 2 17.9698 0.288559 0.934677 25.0864 23.4945 21.3611 -160 1 0.910209 10.3712 1.41143 1.2541 -53.8465 46.4292 -161 2 0.158544 9.88347 1.87089 19.8792 18.5163 -27.3041 -162 2 0.565924 11.0969 0.944383 -23.7591 37.8535 -27.1782 -163 1 1.55407 12.175 3.31087 17.0236 24.8743 53.6813 -164 2 1.36245 11.4802 2.72234 -7.32763 -23.5838 -35.6732 -165 2 1.61623 13.0206 2.87285 0.136729 5.19924 -18.0355 -166 1 0.543127 17.2543 4.88609 31.8084 34.0538 -50.8525 -167 2 0.11032 17.9772 5.31124 -21.3387 12.8349 12.3342 -168 2 0.420366 16.4266 5.2673 -11.294 -44.4064 35.6607 -169 1 1.10053 1.01949 9.38768 20.2638 -3.47079 3.57058 -170 2 1.46081 0.575286 10.1589 5.67003 5.93636 13.5245 -171 2 0.265613 0.594128 9.34525 -28.6257 -3.15214 -10.2647 -172 1 16.8007 2.32783 13.2877 6.99662 17.0137 -29.7497 -173 2 17.0701 2.57314 12.3549 -10.9982 -8.19012 27.7721 -174 2 16.4263 1.43993 13.282 0.147057 -7.47121 1.20179 -175 1 2.45231 15.8283 12.1942 24.161 -10.1121 18.9704 -176 2 2.8623 15.5513 13.0537 -7.72007 6.59246 -26.0318 -177 2 2.91392 15.3801 11.4615 0.0476102 5.48907 2.61928 -178 1 16.435 15.531 5.9458 18.7492 36.0842 -19.2976 -179 2 17.3808 15.5177 6.20547 -11.8351 -4.55683 5.24266 -180 2 16.4147 16.2211 5.22063 -11.381 -14.928 22.2973 -181 1 5.84547 5.02056 11.8065 17.7106 -18.2202 -11.4458 -182 2 5.55799 5.91374 11.8891 -12.2572 20.16 10.1838 -183 2 5.09 4.45915 11.9819 -6.52029 -3.58907 3.63352 -184 1 15.2214 4.86555 0.731755 -13.1216 -14.4231 22.9417 -185 2 14.6776 4.45845 1.47821 22.203 16.7553 -20.5876 -186 2 14.6696 4.95834 18.5986 -12.3693 6.08689 2.65647 -187 1 16.3401 16.2933 2.11217 18.14 -13.9799 -32.9854 -188 2 16.0666 16.7695 2.87319 -13.0548 23.8975 25.5489 -189 2 16.7601 16.9279 1.50378 -12.2165 -0.858221 10.4248 -190 1 0.305885 4.87877 3.79118 -8.03527 51.7998 21.7755 -191 2 0.299338 5.85541 4.09758 -2.9952 -44.8334 -24.4202 -192 2 1.16991 4.5635 4.03062 6.79251 -10.5604 -0.715716 -193 1 2.92501 14.9782 15.0356 -0.55527 3.1583 33.427 -194 2 3.0159 14.7264 15.9987 -0.365372 -5.40078 -25.4532 -195 2 2.35392 15.7535 15.1247 4.98076 9.37108 -6.84819 -196 1 1.1115 14.5727 9.55731 53.2995 18.2393 -15.0567 -197 2 2.08491 14.4157 9.46275 -24.2978 21.5236 -5.71591 -198 2 0.897072 13.7408 9.90248 -27.8007 -35.1999 18.1171 -199 1 13.6501 16.6688 11.5433 6.47975 17.456 -8.04391 -200 2 13.4697 17.4567 10.9694 -3.73037 -22.0736 15.6897 -201 2 13.5721 15.8897 10.9842 -9.76738 -0.866763 -1.05724 -202 1 4.73098 1.47842 0.720986 0.301824 -3.12152 0.469647 -203 2 4.27169 1.98826 0.034225 -8.26683 -3.93854 8.43126 -204 2 4.11741 0.788607 1.06182 2.96071 12.6313 -1.58966 -205 1 1.42158 18.4663 11.9139 -14.1117 26.2958 -21.249 -206 2 1.21766 0.394331 12.6648 1.16138 0.455671 2.39682 -207 2 1.94844 17.765 12.2423 13.6408 -23.7742 11.0988 -208 1 11.5498 10.1018 4.11619 25.3456 17.7005 -19.3629 -209 2 11.5687 10.5955 3.24216 -3.14233 -16.3641 23.7483 -210 2 12.4899 10.1059 4.45555 -25.4417 -1.6091 -14.3563 -211 1 8.38254 12.182 3.76573 -28.852 -4.31545 3.66513 -212 2 9.25863 12.501 4.06076 -17.1001 4.9792 7.32521 -213 2 7.63736 12.4251 4.40785 39.3791 -3.23553 -14.7997 -214 1 14.3228 4.03714 3.29709 9.27375 -1.14036 13.2131 -215 2 14.8928 4.14179 4.10547 -9.51715 0.900554 -20.2647 -216 2 13.4701 4.45558 3.48891 4.64833 -1.13545 4.69814 -217 1 5.58188 1.78199 7.50513 -29.4992 -43.0538 46.7434 -218 2 5.0172 1.13958 8.12095 30.2312 35.5173 -41.7355 -219 2 5.33078 1.59122 6.59529 -0.079259 -3.9625 -11.0752 -220 1 17.9086 1.12503 4.88467 2.95857 -4.16946 -9.18468 -221 2 18.4038 1.54032 4.14207 -4.82318 -1.26447 16.1692 -222 2 17.6814 1.78344 5.55455 4.62183 1.86586 -4.7268 -223 1 6.83101 9.39303 4.49716 -16.0719 2.4093 -32.0921 -224 2 6.83675 9.57499 5.42715 5.68499 0.0447418 21.7322 -225 2 7.66807 8.99049 4.24996 11.5264 2.90932 7.40733 -226 1 2.71406 14.9654 1.962 -15.6661 -3.22344 -28.3015 -227 2 3.33343 14.7912 2.66354 12.1361 -6.91733 6.37301 -228 2 3.09502 14.6645 1.10257 -2.31521 10.6903 23.881 -229 1 17.279 12.8803 13.1283 -15.852 18.187 11.8592 -230 2 16.4044 13.2339 13.3283 -9.52452 -19.4408 0.302495 -231 2 17.6948 13.7346 13.0834 29.0619 4.95471 -11.8483 -232 1 15.0196 10.5818 1.38314 -38.2265 -36.9922 -31.977 -233 2 15.5102 11.1963 1.85791 34.2907 40.991 28.9525 -234 2 14.3351 11.0964 0.933298 3.32659 -5.3471 5.33786 -235 1 5.71789 6.95838 4.52856 0.683996 -27.8748 7.64407 -236 2 5.85266 7.87985 4.34179 3.58991 17.4746 0.820156 -237 2 6.44364 6.70841 5.13514 -10.315 -1.76088 -5.92415 -238 1 8.12142 8.26262 10.159 -0.695069 1.43108 44.445 -239 2 8.58519 8.93965 9.66877 7.60931 4.76567 -12.7632 -240 2 7.56021 7.74854 9.59836 -11.8614 -6.52029 -23.2391 -241 1 13.5311 18.2901 5.8079 -10.639 -13.2321 14.1155 -242 2 12.703 0.102298 5.56963 3.89465 4.4637 5.13268 -243 2 13.2939 17.6289 6.50758 1.00889 22.2284 -14.4481 -244 1 0.327324 2.56344 0.113251 1.70035 12.7901 -0.992224 -245 2 18.009 2.52214 18.5736 8.63965 15.9711 4.89881 -246 2 0.724331 3.48299 0.160564 -21.1536 -24.6374 0.514976 -247 1 12.6396 10.9599 9.76875 -56.8672 19.3176 -11.2335 -248 2 11.6552 10.7306 9.75031 35.1307 23.7735 -5.55284 -249 2 12.944 10.1383 10.0842 27.9729 -33.5927 10.4043 -250 1 0.789377 12.2851 11.08 11.4395 6.49483 14.2632 -251 2 18.4919 12.3017 11.2021 -18.2818 -3.30898 -6.09679 -252 2 1.09088 12.7637 11.8722 5.75277 -12.0493 -6.6955 -253 1 5.04567 7.2193 13.4912 -21.0137 -4.20407 -15.1033 -254 2 5.59899 7.84649 13.0247 8.33052 12.0635 4.31379 -255 2 5.48047 6.97898 14.3058 12.3979 0.954472 8.53674 -256 1 1.28609 6.99027 11.837 -51.8154 -68.8711 -15.2848 -257 2 0.481329 7.14037 11.2978 13.8945 0.267944 10.341 -258 2 1.71601 7.79102 11.8803 31.2664 60.1884 9.92158 -259 1 15.4442 9.46712 12.3088 17.5832 34.764 29.4487 -260 2 15.6103 10.4448 12.4444 -11.1607 -30.7672 -13.8763 -261 2 15.5582 9.10301 13.208 -6.74487 -0.409264 -16.2653 -262 1 16.6404 12.9744 5.44078 0.476019 -21.9889 6.56196 -263 2 16.2955 13.8866 5.54247 3.20084 -14.9841 -16.6056 -264 2 16.51 12.593 4.54035 -6.85686 22.0547 12.2483 -265 1 6.17495 10.0683 0.210584 -24.8048 -7.78292 -31.6597 -266 2 5.35839 10.4511 0.557392 3.36584 -0.936069 -2.46609 -267 2 6.76092 10.0813 0.943985 27.7338 0.90169 16.297 -268 1 12.3644 6.05734 4.04236 -18.3706 -38.3329 30.2118 -269 2 12.4738 6.70802 3.38308 -4.23006 32.9396 -25.2938 -270 2 11.4212 5.77124 4.03221 17.6012 8.78206 -0.800798 -271 1 0.124733 12.8266 0.203961 3.20067 -1.28022 -4.47052 -272 2 0.029974 13.5935 0.786871 -4.13202 -3.19163 0.984476 -273 2 18.185 12.9963 18.0877 7.32574 2.49628 4.77591 -274 1 3.83931 18.5785 8.61972 20.3146 -6.32916 -11.386 -275 2 3.58625 18.36 7.70531 -8.03976 -3.33875 5.01892 -276 2 3.07994 0.282626 9.06556 -19.534 7.19375 -0.404578 -277 1 7.37599 17.2741 4.45241 46.8945 31.0513 1.9622 -278 2 8.02493 17.9603 4.76808 -26.2103 -24.7083 -3.79352 -279 2 7.47725 17.3636 3.49301 -14.0292 -8.10987 6.13371 -280 1 9.20909 17.0315 12.2197 40.0448 -1.21715 18.2255 -281 2 9.48765 16.172 11.8421 -14.9023 11.2095 -3.08284 -282 2 9.99892 17.2887 12.7762 -22.6762 -6.36186 -10.9913 -283 1 13.3284 13.0292 7.94175 -54.0325 -32.963 -10.3586 -284 2 13.0533 12.253 8.47808 14.6554 7.99008 1.85075 -285 2 14.1985 13.2855 8.14946 35.8516 11.3519 14.341 -286 1 14.9871 2.94126 15.3478 14.8638 12.3357 -7.44451 -287 2 14.2243 2.52816 14.9303 4.35222 -7.49481 -2.56315 -288 2 15.7054 3.02501 14.6718 -19.1947 -5.47381 11.1555 -289 1 9.85637 15.4939 17.0026 4.34281 7.61827 -6.92944 -290 2 10.2013 14.6312 16.7411 4.19591 2.79737 -1.68983 -291 2 9.35728 15.3668 17.8085 -9.66212 -2.87408 7.84053 -292 1 11.2848 8.23994 16.5492 3.25751 34.7591 1.5155 -293 2 10.8315 7.75123 15.8747 -12.3664 -15.1549 -6.58201 -294 2 11.7506 7.62533 17.1016 5.33248 -14.8245 8.28699 -295 1 3.77097 18.1898 16.7118 4.01905 33.5947 11.0152 -296 2 4.24576 17.6768 17.3569 8.65949 -22.0954 6.28955 -297 2 3.7978 0.441972 17.1008 -4.25038 -14.6471 -12.4326 -298 1 2.20581 4.09889 8.95874 2.08991 2.93543 4.28652 -299 2 3.00197 3.55544 8.74643 -14.7124 14.9899 14.3923 -300 2 2.10364 4.24367 9.94001 10.2614 -16.6264 -23.5165 -301 1 9.9196 10.3581 9.75231 -25.3187 14.4865 -18.1673 -302 2 9.34403 11.1055 9.40387 23.5511 -18.6954 16.391 -303 2 9.87032 10.282 10.7171 2.48436 10.3271 -7.39297 -304 1 9.73405 0.807167 10.8572 20.2474 21.386 4.54274 -305 2 9.58177 18.5811 11.2204 -17.7151 -14.7389 -0.277185 -306 2 9.10878 1.03014 10.1675 -11.7891 -3.63679 -6.29284 -307 1 9.18221 15.2247 10.2123 -13.9791 -9.46207 -17.3808 -308 2 9.04674 16.0847 9.7631 0.486754 -17.6411 9.75771 -309 2 8.3908 14.6843 9.94105 18.1048 12.7648 16.7376 -310 1 1.00316 9.27987 10.329 16.2357 -30.0069 -12.307 -311 2 1.16727 10.1904 10.5724 12.5584 13.4462 -0.132091 -312 2 1.84996 8.76119 10.1498 -29.1191 35.4904 9.82697 -313 1 16.8004 4.89338 8.19813 20.3933 -12.8673 28.5682 -314 2 16.1748 5.31624 8.83318 13.8703 -8.22156 -17.3769 -315 2 17.4877 4.38941 8.71628 -28.7666 17.1718 -13.9408 -316 1 14.6379 14.6893 0.402347 -11.3933 -1.08114 12.583 -317 2 14.9609 15.3376 1.05877 1.73558 -10.8431 -5.12344 -318 2 13.9048 14.1906 0.841144 16.133 14.0369 -13.7985 -319 1 3.51181 11.0525 9.63829 3.71178 7.51059 -9.42611 -320 2 3.41507 11.3617 10.5484 4.21267 3.5616 -2.2445 -321 2 3.25155 11.8076 9.06383 -1.86739 -11.3951 3.16022 -322 1 11.0289 10.8695 1.26208 17.5529 18.9634 -6.32419 -323 2 11.1535 11.716 0.753779 -2.53448 -25.7082 13.9861 -324 2 10.1142 10.5923 1.16471 -5.76816 1.63272 -1.45278 -325 1 13.2239 7.06188 12.8977 -31.5053 10.0751 -2.41927 -326 2 14.1381 6.84046 12.8922 27.4331 -7.40558 0.979603 -327 2 12.7471 6.22139 12.9668 2.74296 5.12722 -5.48309 -328 1 9.62584 1.88878 0.937813 20.2039 -2.98483 37.6532 -329 2 8.77484 2.11506 0.623903 -27.5663 2.83673 -14.773 -330 2 10.1764 1.70882 0.191067 9.03311 -1.803 -18.3794 -331 1 10.6054 13.537 4.7508 -5.88392 -4.211 -2.61457 -332 2 11.3208 12.9359 5.04367 -2.43279 15.5075 -5.53386 -333 2 10.4128 14.1619 5.47507 10.6777 -11.2442 -5.71889 -334 1 14.2525 1.6915 10.8868 22.6682 20.2673 6.9187 -335 2 15.0842 1.26497 10.6465 -0.175006 -8.05208 -4.1062 -336 2 14.5069 2.62992 10.8824 -12.4791 -0.486299 1.09093 -337 1 14.6678 12.4248 11.7157 -13.2082 -11.6835 -6.16669 -338 2 15.5574 12.5766 11.3177 -21.8957 -10.6844 -5.73724 -339 2 14.0022 11.9667 11.1187 29.6297 15.7618 7.64488 -340 1 8.24065 5.08218 9.78509 -6.47861 44.5837 29.4664 -341 2 7.45364 5.10173 10.3836 14.047 -11.9893 -18.2698 -342 2 8.36822 4.22882 9.41503 -9.58488 -33.9934 -8.19516 -343 1 1.59893 16.8132 18.3262 1.96117 45.1636 -18.3395 -344 2 1.99225 17.1675 17.4932 -11.7114 -3.37836 17.8399 -345 2 1.72693 15.8931 18.2458 8.8364 -33.8164 2.61771 -346 1 1.43382 17.2563 15.3383 72.5903 -10.7327 -13.0674 -347 2 1.32309 18.1562 15.5759 -7.01853 28.114 11.2541 -348 2 0.623143 16.841 15.3782 -65.0193 -20.0106 1.99827 -349 1 3.73599 5.55499 6.2196 -15.153 37.171 -3.6345 -350 2 3.32092 6.26594 6.76194 -0.427016 -18.6419 -6.59332 -351 2 4.19567 6.05321 5.52665 9.16489 -2.39818 -0.177123 -352 1 12.357 9.41487 14.1826 14.7553 -23.0333 -0.513454 -353 2 12.9591 8.63784 13.9021 -31.7094 29.7183 13.6876 -354 2 11.936 9.15457 15.0346 15.6336 0.764049 -11.787 -355 1 4.0362 15.2647 6.90572 29.1452 22.7898 -8.55589 -356 2 3.45744 16.0249 6.7945 -6.03593 0.633302 -6.25525 -357 2 4.92941 15.6518 6.66696 -24.7672 -22.8121 8.07817 -358 1 0.606517 8.56128 14.8606 8.16327 11.3924 -6.42857 -359 2 0.498099 9.52604 14.9437 -1.3098 -5.53798 5.35752 -360 2 1.28855 8.50016 14.167 -7.84877 -5.15776 5.22176 -361 1 12.9763 8.3683 10.3434 -0.844759 8.90572 -31.1716 -362 2 13.7163 7.90436 9.89822 -4.62341 -2.31264 17.3373 -363 2 12.9003 8.0957 11.2534 8.39581 -13.8091 14.665 -364 1 15.2983 7.63672 3.47583 -36.1974 -22.3868 30.0346 -365 2 14.5024 7.10501 3.29647 15.8969 13.8763 -24.8874 -366 2 15.2922 7.47095 4.43335 27.1257 13.219 -1.62631 -367 1 17.3208 6.63818 0.028906 -14.8751 21.4285 -7.11338 -368 2 16.7479 6.05403 0.554933 2.23596 0.744461 -7.2242 -369 2 16.7141 7.27151 18.2009 9.57247 -21.991 17.917 -370 1 8.79355 6.92545 7.84172 -22.0329 -24.5159 21.3067 -371 2 9.63968 7.32585 7.85068 36.717 16.3192 -5.46325 -372 2 8.77688 6.39871 8.67404 -5.56167 6.19415 -17.3543 -373 1 12.3209 0.607808 1.1741 -8.60043 -0.59496 -5.94607 -374 2 12.995 1.15082 1.58835 11.0262 -7.11766 4.69751 -375 2 12.79 18.5825 0.66073 -1.01688 3.73434 3.9163 -376 1 5.68514 15.097 14.5145 8.08213 26.2607 -13.8654 -377 2 4.72797 15.1695 14.4772 -8.65505 -1.66018 8.38379 -378 2 6.02476 15.8935 14.032 -4.56821 -16.9623 16.8148 -379 1 3.822 6.53853 1.67803 10.5239 -7.29529 -10.476 -380 2 3.54968 7.33117 1.17576 -0.94291 -9.86176 19.1013 -381 2 3.81642 6.7886 2.60252 -1.1437 7.90849 5.70077 -382 1 3.89262 11.6088 12.227 12.6183 0.535598 5.61903 -383 2 4.72051 12.1032 12.348 1.21499 -6.42147 -0.654839 -384 2 3.26281 12.0921 12.7526 -15.9809 8.56892 5.74885 -385 1 5.45444 3.88172 15.8755 8.44756 62.1439 23.7417 -386 2 5.90627 3.24049 15.3708 26.1603 -31.2362 -14.1171 -387 2 6.11665 4.65725 15.9739 -35.5554 -35.0069 -5.06549 -388 1 14.4636 10.317 4.39501 5.54347 -18.2961 -43.8287 -389 2 14.9051 9.88853 5.13417 0.162303 -5.91623 3.64337 -390 2 14.7084 9.81768 3.53446 -11.8135 21.0668 42.8202 -391 1 7.94949 17.2895 9.24469 -10.6799 8.8199 -1.02562 -392 2 7.23447 17.5423 9.86969 8.35341 2.50468 -15.9799 -393 2 8.01085 17.8889 8.47627 -8.2125 1.31495 9.33291 -394 1 4.4986 14.4237 3.96317 23.4879 4.54475 27.495 -395 2 4.89523 15.3318 4.14709 -14.6852 -27.1979 0.729547 -396 2 4.80237 13.7713 4.67129 -11.1841 28.5155 -20.9146 -397 1 14.3358 7.38467 15.7635 18.2582 5.36164 1.70543 -398 2 15.2401 7.23754 15.391 -25.5283 4.5174 14.2628 -399 2 14.4998 7.83446 16.6232 -7.00614 -11.7321 -15.3353 -400 1 2.86875 18.2246 1.90934 11.7547 29.7641 47.6357 -401 2 2.54447 17.7626 1.17928 -20.4445 -34.8995 -41.4626 -402 2 2.08284 18.4154 2.45796 12.4063 3.86937 -8.17484 -403 1 7.96139 1.61197 4.52525 30.3503 -5.61589 29.1814 -404 2 7.4985 1.83317 3.72811 -5.85178 12.6793 -14.6648 -405 2 8.84188 2.051 4.57628 -22.8061 -6.44347 -10.2559 -406 1 2.69247 14.1251 17.7583 -44.9975 -8.30966 9.027 -407 2 1.78944 13.8074 18.0556 29.9332 0.951363 -12.1679 -408 2 3.33089 13.517 18.1683 -0.885538 6.08231 -6.55793 -409 1 0.711797 1.68055 13.8626 46.1903 -0.903658 -18.4125 -410 2 0.854596 1.56791 14.7929 -3.1534 -4.53792 18.4431 -411 2 18.4557 1.86826 13.7064 -36.4408 7.03813 3.66844 -412 1 4.5582 18.5986 13.9691 16.7448 -5.62304 -20.7496 -413 2 5.37614 18.0918 13.7297 -17.5024 17.6116 13.2075 -414 2 4.4096 18.4453 14.9034 -5.9637 -5.97884 8.59903 -415 1 7.10973 0.453475 18.3742 -15.9095 45.4284 35.234 -416 2 6.99644 0.098599 17.5235 1.36411 -17.312 -40.4978 -417 2 6.34312 1.05085 18.5323 11.251 -17.9428 -0.916775 -418 1 16.0934 18.4421 14.1505 -12.1616 -21.5095 -38.715 -419 2 15.444 17.7866 13.7542 19.2119 24.6311 23.4234 -420 2 16.0379 18.4915 15.109 -11.392 0.0248185 1.48898 -421 1 10.1156 4.52417 16.2956 -62.1497 -10.7811 -30.3439 -422 2 10.9808 4.34247 16.5381 55.5233 -0.530433 19.4573 -423 2 9.84863 3.69679 15.8473 1.30878 12.8229 10.5952 -424 1 15.8226 17.9425 4.41327 -8.6596 2.53656 28.4341 -425 2 16.5547 18.5732 4.53052 -7.53986 -1.28134 -1.76301 -426 2 15.1071 18.2295 5.06915 24.8326 -13.5436 -35.3744 -427 1 6.9246 17.3574 13.7412 35.4232 12.1969 -4.79491 -428 2 7.49648 17.8115 14.4369 -19.095 -19.6264 -17.6052 -429 2 7.52703 17.1963 12.9658 -8.44681 6.90552 21.4872 -430 1 13.2892 6.57209 6.73437 -47.4462 -6.01427 11.894 -431 2 14.2146 6.66317 6.83486 37.5911 0.460957 -13.6759 -432 2 13.0394 6.38579 5.82242 8.60231 0.411312 -6.48828 -433 1 7.6616 2.3861 9.17526 11.1339 -5.58665 -35.6695 -434 2 7.32169 2.39592 10.0555 -17.0215 -5.04529 20.6135 -435 2 6.95914 2.1022 8.53308 18.7558 7.43711 21.2842 -436 1 15.1464 14.8771 13.6482 -7.73724 1.21311 0.537171 -437 2 15.0308 15.0223 14.6069 -1.84691 1.26092 -11.2626 -438 2 14.3194 15.1152 13.1798 14.9291 -3.65447 11.731 -439 1 9.29105 8.34315 3.70472 21.3149 -22.535 5.81715 -440 2 10.1776 8.75859 3.73678 -10.082 3.55323 2.49013 -441 2 9.48378 7.39942 3.88081 -6.26995 14.6936 -2.40173 -442 1 17.6854 13.4687 16.4528 7.27147 30.461 -18.2669 -443 2 16.7357 13.4337 16.3398 -4.89197 -8.49248 4.47316 -444 2 17.8844 14.3284 16.0065 3.65909 -18.1112 10.9221 -445 1 5.04883 10.6547 2.58751 22.4142 -14.5409 3.1837 -446 2 5.87017 10.3468 3.04382 -22.783 5.18619 -3.79272 -447 2 4.55197 11.1441 3.22928 -6.35653 9.92745 13.9967 -448 1 3.70566 8.3683 10.3381 0.421872 -35.3081 -1.7593 -449 2 3.86061 9.29726 10.2176 3.60826 23.2513 -1.90293 -450 2 3.86652 8.14601 11.2715 -1.83662 8.64514 -7.63686 -451 1 16.1079 7.11641 6.33859 18.7251 -13.7954 -9.96454 -452 2 16.7241 7.70559 6.80408 -7.87205 -5.85527 -7.24175 -453 2 16.6678 6.33083 6.12136 -22.8952 10.0887 6.36104 -454 1 15.2027 7.00502 9.1117 -13.5711 31.2066 -33.9348 -455 2 16.009 7.42176 9.46585 -10.2898 -7.03399 -7.73296 -456 2 14.9881 7.51375 8.25647 13.8068 -20.3115 41.0185 -457 1 6.4525 13.1649 12.9201 -16.9811 1.25576 1.12717 -458 2 7.2977 12.7289 13.0561 1.55279 -4.02118 8.73008 -459 2 6.25327 13.7237 13.7059 9.12735 -9.15034 -19.1848 -460 1 12.1145 4.49786 13.0694 62.3048 41.2439 -0.723073 -461 2 12.3852 4.68406 13.9868 -14.3297 -10.0558 -0.292641 -462 2 11.3952 3.9317 13.0199 -52.2119 -35.1204 4.15665 -463 1 11.3323 8.18365 7.8522 27.7169 3.03613 12.328 -464 2 12.0901 7.73501 7.43634 -12.9205 -4.29619 -7.69129 -465 2 11.7651 8.45102 8.68662 -18.4456 -0.736999 -3.04515 -466 1 17.1666 10.776 7.42179 36.4822 -17.3878 -25.363 -467 2 17.7906 10.0723 7.08441 -17.5934 13.4566 22.3886 -468 2 17.2793 11.4524 6.73733 -15.3427 2.84073 7.18141 -469 1 5.22802 18.1471 11.05 -23.1388 -14.8798 2.48444 -470 2 4.73762 18.1049 11.901 7.4508 0.565766 -17.6495 -471 2 4.62535 17.7417 10.374 17.7336 12.8347 12.9373 -472 1 7.56653 17.6363 1.80821 4.35794 -3.26776 57.5888 -473 2 7.65741 16.7768 1.42856 9.05039 -19.6913 -22.9027 -474 2 7.35855 18.2549 1.13994 -1.37991 13.1573 -30.1972 -475 1 1.85092 12.9256 13.6076 18.7065 20.702 19.2299 -476 2 1.72104 12.4156 14.4258 -5.54537 -0.960406 -11.4426 -477 2 2.19932 13.7866 13.9501 -8.88955 -22.8153 -6.43965 -478 1 9.73868 6.79159 14.8001 -20.0718 45.6966 0.235719 -479 2 9.95236 5.95211 15.1529 12.0129 -40.6355 11.2206 -480 2 9.967 6.84408 13.8723 5.59208 -5.10263 -8.66058 -481 1 15.2087 4.3972 10.7794 -27.6923 -26.0969 -27.5028 -482 2 16.0082 3.89203 10.8637 26.1176 6.2885 5.33656 -483 2 15.2102 5.16148 11.3322 8.48984 16.211 19.3779 -484 1 11.1963 6.12482 0.150068 -21.1972 -23.7011 14.8212 -485 2 11.2381 5.20796 0.481504 11.4486 12.9471 -10.1704 -486 2 10.2374 6.21547 18.6186 14.0424 14.8346 -3.67395 -487 1 0.19533 11.3359 15.1413 -20.6703 11.3325 -28.7309 -488 2 18.4021 11.874 14.3993 9.91215 -19.3636 27.3138 -489 2 18.4481 11.661 15.9631 4.36494 9.01906 -3.16307 -490 1 7.06882 9.13032 7.26059 -19.4655 -1.24154 14.8953 -491 2 6.55985 8.40099 7.69941 12.6354 16.9737 -16.1687 -492 2 7.9725 8.82922 7.21375 8.43039 -5.65083 0.275054 -493 1 18.4578 15.4507 12.3537 3.87705 -1.0699 -4.92487 -494 2 0.776651 15.5698 12.2511 -12.7177 -2.03387 6.80581 -495 2 18.1456 15.6789 11.4721 -4.67377 -0.406651 0.743757 -496 1 16.5694 4.36967 5.25107 0.98709 -29.8421 42.9348 -497 2 16.7744 3.81151 6.06026 -19.0257 27.4778 -23.1846 -498 2 17.3898 4.32671 4.78168 15.572 7.21618 -21.1326 -499 1 17.788 3.06911 10.7078 7.64381 16.9425 17.2861 -500 2 0.075758 3.1322 11.0257 -14.4921 -2.82201 -9.29777 -501 2 17.6332 2.20749 10.3226 4.29805 -13.9207 -6.70838 -502 1 12.3142 0.064083 10.1758 -16.2036 46.6093 2.93236 -503 2 11.3746 0.384648 10.259 24.7548 -16.9496 1.0795 -504 2 12.8178 0.919304 10.3228 -10.1981 -36.9052 -8.89593 -505 1 10.3666 9.83315 12.2981 10.0643 6.74252 24.9843 -506 2 11.1015 9.85063 12.955 -7.48254 2.69098 -11.3777 -507 2 10.1328 8.91188 12.2898 -1.25875 -17.3524 -2.69444 -508 1 0.463654 2.82678 7.01839 23.1504 30.9543 10.494 -509 2 0.875324 3.58845 7.48211 -15.8261 -9.71426 -11.3384 -510 2 0.770257 2.12665 7.58365 -2.51696 -19.6875 3.88184 -511 1 0.478371 15.2358 6.91004 -5.36214 -57.1351 9.88058 -512 2 0.585298 15.6463 7.75647 2.33624 13.0536 15.0713 -513 2 0.556531 14.2524 7.18353 -2.6234 48.5984 -27.3232 -514 1 16.9534 7.00251 15.3394 -19.8576 7.98442 -8.98385 -515 2 17.6338 7.63543 15.0899 18.202 -5.57661 4.9227 -516 2 17.3093 6.19568 15.7235 12.2576 0.0838452 -6.46227 -517 1 9.0001 12.4151 8.13768 -31.7276 34.3494 27.7642 -518 2 9.37386 11.8218 7.49742 -2.69042 -17.0115 -24.8182 -519 2 8.02402 12.632 8.03373 37.271 -17.4326 -7.14384 -520 1 1.27238 1.95406 3.05803 -14.2139 -9.70678 -17.9319 -521 2 1.26084 2.61511 2.34121 0.72572 -7.36998 11.1944 -522 2 1.89031 2.22344 3.73293 7.71835 10.2015 -2.21509 -523 1 4.13907 15.1156 9.62039 -24.138 8.67184 14.727 -524 2 4.07003 15.1439 8.65747 7.76366 -2.53025 0.663124 -525 2 4.96029 14.7006 9.86457 16.019 -6.11163 -3.79055 -526 1 7.17628 2.17866 14.5671 8.05543 15.8774 -0.750343 -527 2 6.99528 1.68402 13.7698 -4.08254 -5.57585 -6.74919 -528 2 7.62131 2.98432 14.249 -3.31184 -9.11349 9.13274 -529 1 18.6082 14.7131 2.1481 32.1263 -19.3615 -2.59353 -530 2 0.838003 15.1297 2.25966 -2.55576 -5.62694 -3.02712 -531 2 17.988 15.3544 2.42675 -29.4597 23.3621 5.14018 -532 1 9.94138 2.79524 12.9422 18.0301 -20.084 -2.65944 -533 2 9.79404 2.1456 12.2228 -2.72579 10.1868 5.0837 -534 2 9.17835 3.36299 13.0326 -9.76513 7.42125 -6.32672 -535 1 2.80444 8.90955 13.0076 -21.3878 -12.6555 -0.633582 -536 2 3.06361 9.80599 12.872 11.8276 24.8177 -4.92621 -537 2 3.5122 8.48618 13.4775 16.8101 -10.8298 6.5617 -538 1 3.236 8.3574 3.63664 -3.24123 -25.7508 65.6997 -539 2 3.45085 9.0718 3.07326 14.699 31.6407 -15.7982 -540 2 3.47645 8.58669 4.60794 -10.8292 -3.55345 -46.4885 -541 1 5.62853 7.18594 8.51094 13.0444 23.9613 2.26298 -542 2 5.46784 6.31815 8.13889 -4.11832 -12.799 10.1434 -543 2 4.96415 7.47792 9.15047 -6.22666 -11.1251 -0.517113 -544 1 14.8757 1.26039 2.01768 6.89853 7.12439 -27.6668 -545 2 14.9353 2.01952 2.56559 -6.08088 15.4811 28.5729 -546 2 15.2784 1.60993 1.21235 -3.12956 -15.001 -5.59525 -547 1 8.22892 15.2012 0.850139 9.01324 -8.86779 5.43529 -548 2 9.02213 14.9338 1.33488 4.41045 13.1537 -1.08033 -549 2 7.55366 14.6663 1.27665 -10.9347 0.418265 -6.06235 -550 1 15.6387 1.34587 7.23673 -34.4855 -14.424 -6.72803 -551 2 14.9277 0.724731 6.91269 25.2779 16.6902 6.4887 -552 2 15.1173 2.1119 7.53894 8.3028 -0.775331 -5.89355 -553 1 4.90142 13.0959 18.5232 17.5611 -6.682 24.5871 -554 2 5.32755 13.082 0.76977 -9.23128 1.69535 -18.7742 -555 2 5.44764 13.7122 18.0259 4.92611 -3.73779 -6.82361 -556 1 15.3368 8.46948 18.1479 24.407 23.6523 -18.6734 -557 2 15.8061 9.12264 17.5623 -15.0725 -19.5419 9.94084 -558 2 15.3318 8.91689 0.353875 -7.67765 1.6761 7.06822 -559 1 12.0708 3.01842 18.3809 -8.57811 34.9919 -15.9288 -560 2 11.9316 2.65996 0.60646 7.37996 -15.8634 5.79137 -561 2 12.6022 2.47389 17.7995 4.55547 -17.8211 5.72515 -562 1 13.2139 12.6752 5.17768 -11.8856 9.18106 -10.9384 -563 2 13.7464 12.0348 4.69253 2.29692 -7.56952 8.05888 -564 2 13.2564 12.5123 6.11793 11.0077 -2.72782 9.02039 -565 1 6.05443 7.0356 0.031519 0.145276 -19.8641 5.27909 -566 2 5.93935 7.95118 18.5019 2.68887 36.361 -1.99394 -567 2 5.39095 6.86665 0.702638 -10.5375 -11.3291 0.555603 -568 1 17.7528 16.0276 15.0213 -26.9751 8.08167 9.65398 -569 2 16.9476 16.5457 15.105 2.62193 -2.13449 20.9775 -570 2 17.7479 16.0055 14.0813 23.0391 -15.2709 -33.7916 -571 1 13.196 0.994907 16.5363 6.64944 3.5152 15.0268 -572 2 14.1481 0.997912 16.7614 -13.0846 -5.94027 -6.50206 -573 2 12.8833 0.094199 16.7238 3.13951 3.25376 -8.62791 -574 1 11.1253 14.5647 7.20271 12.6179 20.8985 -18.374 -575 2 10.4007 14.3183 7.72981 -32.928 -10.0181 24.5345 -576 2 11.7186 13.8255 7.26943 16.9686 -3.76464 3.70387 -577 1 17.5081 8.62849 2.08107 18.4536 39.9223 21.5452 -578 2 16.6801 8.63471 2.55495 -14.8656 -12.3201 1.9096 -579 2 17.5233 7.88242 1.516 -5.44609 -31.2556 -23.2052 -580 1 12.3547 8.01168 2.02213 3.34817 7.10659 0.607451 -581 2 12.2384 8.8582 1.54611 -2.17098 -11.1853 7.9144 -582 2 11.9739 7.3152 1.48261 -5.38076 0.52639 -15.2068 -583 1 11.8761 14.6165 10.3364 1.47614 -26.5661 -12.796 -584 2 12.1004 13.7873 9.81464 -15.4397 33.1565 21.8304 -585 2 10.8993 14.6888 10.473 20.8283 -4.95583 -12.7008 -586 1 6.89524 7.05211 15.6117 0.948881 6.37495 10.6055 -587 2 7.81004 7.26536 15.3122 -15.6925 -0.985911 8.93516 -588 2 6.66676 7.54167 16.4408 13.3623 -9.35483 -24.2683 -589 1 8.00326 4.73593 13.4743 46.4542 16.9938 22.3473 -590 2 7.23337 4.7302 12.9572 -38.0428 3.58552 -28.1525 -591 2 8.40671 5.62958 13.343 -10.0413 -24.497 3.68285 -592 1 13.4128 12.1818 14.2522 -5.09814 -0.706424 13.2965 -593 2 12.9414 11.3292 14.2657 9.08717 -0.174959 -7.02282 -594 2 13.7875 12.315 13.3696 0.74786 -2.13255 -0.749325 -595 1 14.8395 9.42189 7.30548 -8.6508 -34.4179 -15.7659 -596 2 15.7087 9.765 7.42505 16.3683 18.0856 5.12693 -597 2 14.2269 10.0768 7.57319 -16.6679 19.7312 11.3719 -598 1 12.6526 17.0686 3.07252 -27.098 39.8252 10.9251 -599 2 12.8376 17.5237 3.93373 4.63929 -18.9198 -22.9156 -600 2 11.9913 17.6958 2.63477 30.4514 -31.1971 13.898 -601 1 1.15545 7.13838 17.4647 3.17244 9.59861 -23.4243 -602 2 0.330359 7.36323 17.9184 0.96629 -9.78644 0.159833 -603 2 1.05514 7.47868 16.5422 0.732192 -3.11516 17.9471 -604 1 12.7562 5.15096 15.6457 43.4314 -6.34677 13.892 -605 2 13.4512 4.55662 16.0315 -22.7809 11.2033 -14.7919 -606 2 13.2414 6.00335 15.5788 -11.6166 -6.13865 2.23982 -607 1 2.53993 3.38757 4.97618 -22.6627 40.6834 48.2045 -608 2 1.7609 3.18232 5.58922 26.9518 1.19035 -20.1247 -609 2 2.84154 4.31546 5.27885 -5.90416 -46.089 -11.2441 -610 1 8.33186 11.2983 13.4548 -26.6082 5.68838 43.1719 -611 2 8.4244 11.0562 14.4444 7.75654 0.873515 -50.9507 -612 2 8.91168 10.8786 12.8197 22.3442 -13.0535 12.4472 -613 1 12.8689 1.31514 13.3384 2.90045 58.5941 -12.9641 -614 2 13.42 1.58034 12.5659 -7.54964 -19.9936 10.3698 -615 2 12.4231 2.17844 13.5496 8.73522 -32.0886 -3.11014 -616 1 6.34008 13.7169 2.14963 -18.1698 -8.87317 18.5321 -617 2 5.63978 13.877 2.82959 15.2612 6.49493 -20.3543 -618 2 6.88351 13.0442 2.56282 10.2537 -4.17084 0.110729 -619 1 15.9206 6.61444 12.7992 -24.6515 -28.5257 0.353752 -620 2 16.3106 7.25195 12.2393 18.8127 19.5603 -18.6955 -621 2 16.4213 6.59661 13.608 8.17022 1.84551 14.3752 -622 1 16.8298 0.712824 9.59482 4.92561 -19.6459 1.56363 -623 2 16.8791 18.3713 9.72616 -6.7933 22.7031 -2.37673 -624 2 16.5452 0.8605 8.67269 -3.47063 -2.57745 5.28583 -625 1 6.14624 11.7631 8.37671 0.810232 -55.5778 6.71556 -626 2 5.32447 11.4591 8.84151 13.2611 12.3623 -11.7456 -627 2 6.64226 10.8931 8.20176 -18.8432 36.5086 0.169281 -628 1 2.88754 8.61261 0.453821 16.629 -12.4076 -25.9584 -629 2 2.45212 8.04764 18.3917 -7.9132 30.8844 23.5565 -630 2 2.34875 9.28564 0.895642 -16.9187 -4.58083 -11.1609 -631 1 10.1674 10.4623 6.50123 2.03347 0.962837 -14.0367 -632 2 10.6087 9.69731 6.89122 -0.033473 -1.16532 5.68604 -633 2 10.4694 10.4636 5.56932 -4.02396 0.831062 14.2442 -634 1 6.7142 15.6951 6.55167 21.2433 7.58031 13.0519 -635 2 7.14328 16.1838 7.27089 -7.64643 -7.38759 2.93585 -636 2 7.21237 16.006 5.79102 -10.2318 7.90387 -13.7372 -637 1 6.445 13.1807 5.57797 -4.95716 -23.6388 -1.26087 -638 2 6.7301 13.9465 6.07331 -1.77634 9.04977 6.94523 -639 2 6.09943 12.5433 6.22286 1.34041 6.33507 -0.553394 -640 1 16.8242 12.5629 9.83758 4.06472 -20.7324 4.78658 -641 2 16.9985 11.8651 9.16533 -5.27225 15.8277 3.76725 -642 2 16.5644 13.3844 9.42716 1.03985 5.07871 -11.9 -643 1 6.03738 2.95058 2.86354 -7.03855 -25.5492 -1.19629 -644 2 6.40977 3.757 2.57075 15.9289 34.7492 -4.17594 -645 2 5.57703 2.61747 2.09059 -4.9021 -9.32473 -6.53819 -646 1 10.9114 3.33767 3.30112 5.22699 -4.50477 6.26496 -647 2 10.297 4.02722 3.58926 -1.95634 -6.20434 -4.73409 -648 2 10.5127 2.84524 2.57795 -5.80356 2.60284 -4.41077 -ITEM: TIMESTEP -10 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.68613 7.08001 17.9478 -7.01358 -5.91592 2.73538 -2 2 7.77987 6.83016 18.2266 16.0785 4.58355 -9.56375 -3 2 8.81561 6.77572 17.042 -2.60158 -2.67368 4.89818 -4 1 18.5411 8.25019 6.8397 -3.31911 20.0829 53.2463 -5 2 0.132112 7.95881 5.98338 15.0803 -17.7916 -37.9407 -6 2 0.419079 7.77779 7.52768 -3.57438 0.834533 -17.4022 -7 1 8.38502 18.5543 6.8162 17.8503 9.74549 -0.663478 -8 2 9.33656 0.12202 6.71165 -15.3958 -3.25669 1.14423 -9 2 7.91896 0.595612 6.31609 0.0971505 0.0480551 2.20998 -10 1 6.59239 1.84347 11.7106 33.6248 -3.3918 -11.5419 -11 2 5.88602 2.36507 12.0365 -24.0057 14.4643 13.3031 -12 2 6.19621 1.03555 11.4016 -9.54455 -15.1367 -3.43817 -13 1 7.13469 5.75647 2.33282 -16.0707 1.2807 18.6339 -14 2 6.47472 6.10605 3.02238 22.3175 -2.25238 -34.2201 -15 2 7.09016 6.23688 1.47486 -10.0175 -2.52095 21.7818 -16 1 16.2156 10.1493 16.1334 -27.9935 4.46583 14.8083 -17 2 17.0011 10.2168 15.6173 19.2784 7.57164 -10.1711 -18 2 15.8457 11.0427 16.2776 9.29404 -6.61316 -4.9073 -19 1 10.6069 15.0238 2.30809 -6.31705 -20.7544 -7.43742 -20 2 10.5597 14.4327 3.07214 -0.102442 0.508968 4.74876 -21 2 11.0526 15.7982 2.62807 10.1844 15.1967 6.36644 -22 1 17.1594 8.2489 10.3903 7.52685 0.546464 5.9579 -23 2 16.5819 8.79937 10.9325 -0.0424193 4.91704 3.34034 -24 2 17.9857 8.74574 10.257 -6.36369 -4.03495 0.916497 -25 1 14.8922 15.8683 16.3299 23.5339 -10.8154 7.03311 -26 2 14.0097 16.1903 16.2206 -28.4756 7.26009 1.81472 -27 2 14.9055 15.3621 17.1614 -4.45807 1.9077 -0.883551 -28 1 12.1657 13.3863 0.41518 7.67499 -13.0963 13.9948 -29 2 12.1102 13.7181 18.1579 -7.06431 5.66946 -3.72811 -30 2 11.6673 13.9211 1.04936 -4.85696 8.50836 -7.81927 -31 1 9.27628 5.36844 4.05123 -34.192 4.59602 9.65195 -32 2 8.65917 5.24858 4.84371 24.3198 3.71877 -28.2857 -33 2 8.65376 5.51218 3.29446 11.8948 -3.58803 14.2972 -34 1 1.82985 4.27304 11.6494 -12.5424 24.0017 -6.14821 -35 2 1.72713 5.22025 11.9335 1.67264 -20.3932 -8.37626 -36 2 2.38183 3.84857 12.2925 10.2742 -10.1374 14.5925 -37 1 1.96666 6.8371 8.3675 -1.07206 -9.37897 -7.64517 -38 2 2.48137 7.16021 9.09528 7.6819 14.0614 11.7347 -39 2 1.91994 5.89719 8.57067 -2.65468 -6.85216 -5.3032 -40 1 5.40566 4.39875 7.93795 -15.0212 -10.7202 -17.6012 -41 2 5.47911 3.43644 7.82861 5.00513 7.47325 10.3929 -42 2 4.74947 4.60653 7.2496 8.53973 6.88839 10.8311 -43 1 3.24286 2.9209 17.5475 -3.50993 31.6723 15.8788 -44 2 3.91538 3.33593 16.9792 1.14815 -4.85754 -1.50754 -45 2 2.90196 3.68515 18.1088 4.46159 -27.603 -16.229 -46 1 7.46543 5.27113 6.11173 -0.267366 -14.8618 42.036 -47 2 7.89952 5.61794 6.92737 -2.28349 10.3868 -28.0837 -48 2 7.00366 4.5014 6.50229 0.780861 12.0869 -17.1147 -49 1 9.7753 7.01959 11.9799 12.4421 -0.327694 33.7281 -50 2 10.3285 6.37932 11.5448 5.34489 -7.46932 -11.0014 -51 2 9.14168 7.33293 11.3548 -18.5265 5.10994 -23.2436 -52 1 14.1114 3.54906 8.03925 -21.2079 2.70274 -24.764 -53 2 13.5379 4.24737 7.67406 9.42135 -8.95765 0.532077 -54 2 14.4057 3.90023 8.85862 11.8721 11.0917 26.6467 -55 1 4.80077 17.263 4.02669 -14.2573 4.92943 -10.2324 -56 2 5.55275 17.8868 4.11075 -15.7048 -9.31229 -6.31173 -57 2 4.21849 17.485 3.25536 16.798 3.03083 13.1086 -58 1 16.5008 16.6241 10.052 9.35033 0.377019 -20.0251 -59 2 16.0742 16.3966 10.8515 -13.0635 -0.25069 32.9814 -60 2 15.9476 16.1716 9.40786 2.84148 0.00630379 -7.36632 -61 1 1.95698 4.92664 0.48601 10.6785 6.17321 -0.923017 -62 2 2.54546 5.28332 1.19783 -10.1544 -3.94981 -19.1082 -63 2 1.86706 5.64777 18.4726 -0.259245 -4.73099 10.3692 -64 1 11.8035 13.3621 16.2801 -12.0315 -31.2076 -16.8087 -65 2 11.3006 12.5351 16.4295 -1.37085 13.2186 10.8936 -66 2 12.2283 13.1244 15.4353 5.36339 15.8055 8.10642 -67 1 10.1086 11.0623 16.95 16.2363 -23.6439 1.11167 -68 2 10.572 10.1938 17.105 -14.3776 22.5927 -6.24497 -69 2 9.21542 10.8357 16.6616 -0.160324 -0.0991661 2.29857 -70 1 11.7231 17.5369 13.4667 -11.0418 -25.624 2.08744 -71 2 12.2825 16.9797 12.896 1.06573 10.1819 1.6514 -72 2 12.0497 18.4302 13.3866 8.679 12.3703 -3.21063 -73 1 6.34404 9.31427 12.2267 -10.7289 -25.2447 -16.4149 -74 2 6.95388 8.98312 11.5319 -2.39052 10.1346 10.7157 -75 2 6.76108 10.0063 12.722 17.2241 14.9443 4.4156 -76 1 16.2191 12.7237 2.7003 -6.42998 -13.8373 4.3175 -77 2 16.9936 13.1939 2.44509 26.0904 7.71252 -7.79508 -78 2 15.5637 13.4111 2.72948 -20.2851 11.8065 3.04981 -79 1 0.635855 12.5646 5.86231 -29.6975 10.9384 -12.0161 -80 2 0.906184 12.4779 4.92975 2.15237 -1.21985 12.1118 -81 2 18.3245 12.8391 5.75844 29.6273 -11.2198 7.31028 -82 1 5.19222 16.3868 18.4948 24.5889 -0.529385 -6.85369 -83 2 5.88953 15.8781 18.0466 -13.534 -2.69513 -2.10794 -84 2 5.71609 16.8872 0.480999 -10.5805 4.6302 6.45748 -85 1 0.515864 7.62939 4.0653 41.0474 19.9956 -23.6294 -86 2 18.5677 8.05158 3.40199 9.2753 -7.28591 11.0746 -87 2 1.47269 7.84683 3.73678 -46.4137 -9.00167 19.6367 -88 1 3.14217 8.89553 6.52533 -39.0459 6.50689 -6.5056 -89 2 3.57285 8.63007 7.33767 0.0694837 -1.26665 5.56399 -90 2 2.14756 8.93745 6.67407 38.5311 -3.64433 -0.906695 -91 1 7.31414 10.3036 16.1763 -22.1518 3.21861 21.8391 -92 2 6.53268 10.4772 15.6415 8.43374 -0.0418936 -5.11234 -93 2 6.92709 10.2964 17.0866 13.3044 -2.27208 -10.5118 -94 1 11.1096 1.06093 5.00144 -6.80657 -2.48033 -19.8934 -95 2 11.1672 1.90146 4.5306 6.84499 7.0717 9.43568 -96 2 10.7236 0.515071 4.29558 2.64862 -9.02148 12.7331 -97 1 4.44354 2.70015 13.2121 -7.85281 -5.62302 -11.5877 -98 2 4.59136 3.20795 14.0303 0.103412 -15.4758 0.294405 -99 2 4.3686 1.71349 13.3622 2.85998 26.6352 12.1157 -100 1 8.41457 10.0307 1.78829 1.66015 -12.4273 17.1623 -101 2 8.40835 10.6665 2.53096 -1.47245 -0.417386 -5.09881 -102 2 8.60407 9.1525 2.20287 -3.10051 22.5249 -10.5265 -103 1 10.5229 1.75436 15.5533 -10.8574 -2.31 -4.36647 -104 2 11.4367 1.69676 15.8141 13.1269 -3.82494 7.61076 -105 2 10.5487 1.84704 14.5957 -9.26118 2.80358 -1.94415 -106 1 2.76968 12.9399 7.75003 -7.62511 -10.5749 7.18171 -107 2 3.32023 13.5874 7.29614 -2.30989 2.01815 -3.81018 -108 2 2.03946 12.7099 7.15165 5.79412 3.19458 -2.23462 -109 1 3.64251 11.6901 5.3273 -16.0178 -10.9709 -3.95767 -110 2 3.35804 11.041 6.0007 8.31372 10.277 -11.7948 -111 2 2.86611 11.8409 4.75105 13.6859 -0.281218 5.78901 -112 1 6.88155 14.4797 16.8524 -8.387 2.95998 -0.938339 -113 2 7.57426 13.8507 16.6622 5.60788 -2.76391 3.60002 -114 2 6.54738 14.7428 15.9834 -3.14908 -1.19839 3.78249 -115 1 14.1759 14.5423 3.40785 14.1775 -0.803279 -11.9449 -116 2 13.6583 15.316 3.2037 -5.78511 13.0134 -4.56688 -117 2 13.7723 14.1777 4.18517 -7.95121 -12.1195 11.7606 -118 1 8.26975 18.1784 16.0718 57.0984 -9.85256 5.13508 -119 2 8.90468 17.4721 16.3223 -30.0265 -6.05197 -2.08742 -120 2 8.93252 0.246004 16.0158 -21.102 13.2242 -8.22396 -121 1 4.73201 1.6168 4.90814 8.59128 29.3629 -19.7592 -122 2 3.91099 2.13549 5.04668 12.4977 -9.17326 -4.88478 -123 2 5.26431 2.14928 4.23236 -22.3039 -21.7635 28.9569 -124 1 15.1182 12.8405 16.4381 19.169 -3.61406 36.631 -125 2 14.6612 12.9963 17.2965 -1.87916 -0.605635 -21.6052 -126 2 14.5331 12.7051 15.7087 -30.2626 -2.71441 -16.8094 -127 1 15.786 18.3864 16.793 25.1295 13.8681 33.7963 -128 2 16.4578 18.6099 17.5315 -31.6416 -14.5347 -31.3905 -129 2 15.6162 17.4305 16.8164 1.02724 4.80811 3.46398 -130 1 1.14089 1.13731 16.5539 1.05247 19.7088 19.8175 -131 2 1.92337 1.60495 16.9036 -3.97271 -4.80748 -10.3705 -132 2 0.461096 1.48073 17.164 6.66439 -11.1518 -10.5802 -133 1 18.0862 4.58432 15.8734 11.1688 -12.2484 -2.69667 -134 2 18.5694 3.95442 15.2994 -8.21946 11.4291 8.6944 -135 2 18.5872 4.69164 16.6898 0.203498 -2.64567 -2.95902 -136 1 12.2303 16.9505 16.1288 -38.2728 -13.2591 26.8237 -137 2 11.3888 16.5791 16.5378 36.1694 7.82178 -3.50336 -138 2 11.9114 17.1502 15.2549 6.78701 5.10115 -22.4581 -139 1 15.8814 2.54765 17.9709 5.97775 7.55467 -0.319093 -140 2 15.7733 3.43717 18.3784 -1.8513 -17.3861 -11.5789 -141 2 15.6471 2.5946 17.0126 2.53833 6.86428 19.1803 -142 1 6.70799 13.8021 10.253 -1.58408 1.43394 8.76454 -143 2 6.59288 13.5189 11.1728 1.36627 8.87991 1.27306 -144 2 6.58321 12.9942 9.75946 1.30239 -6.02422 -13.3165 -145 1 10.1413 18.2148 2.80353 9.44086 30.3012 -19.3156 -146 2 10.2266 0.305071 2.14691 0.267733 -14.8877 14.3982 -147 2 9.27777 17.8669 2.60695 -13.096 -6.5965 0.845742 -148 1 2.97176 17.7529 6.06326 -6.30899 -0.645097 35.0899 -149 2 2.08427 17.6133 5.69483 9.57331 2.68214 -12.771 -150 2 3.63239 17.8017 5.37586 1.28926 -2.69105 -18.2517 -151 1 12.5668 16.9974 7.96757 -20.2971 -18.5655 21.3419 -152 2 11.8856 16.2971 7.95074 9.26888 3.31932 -10.856 -153 2 12.3344 17.4798 8.78306 11.437 7.92329 -7.28752 -154 1 14.8861 15.2795 8.28974 -15.7554 0.3814 10.2226 -155 2 14.0374 15.7294 8.25106 -5.80199 2.88483 11.5438 -156 2 15.1981 15.4683 7.42207 26.2963 -2.4275 -26.3232 -157 1 17.5473 18.3112 0.374559 -18.2134 -6.45531 -4.6775 -158 2 18.2634 17.761 0.12213 22.8374 -25.4457 -15.3465 -159 2 17.9951 0.303427 0.894204 5.3706 29.2695 18.8411 -160 1 0.910079 10.3754 1.4141 -19.386 -45.7403 28.0244 -161 2 0.0926857 9.86966 1.69283 27.9138 11.9581 -5.7438 -162 2 0.554372 11.07 0.90565 -10.4877 37.4892 -28.5805 -163 1 1.56425 12.1843 3.32385 10.4497 17.8757 14.7846 -164 2 1.39557 11.5297 2.67534 -6.58566 -33.3087 -13.0061 -165 2 1.62643 12.9551 2.76927 3.66066 18.4363 0.784965 -166 1 0.55148 17.2559 4.87768 14.7947 16.704 -22.83 -167 2 -0.0171494 17.9122 5.24737 -12.9669 22.3753 -0.718336 -168 2 0.416337 16.5086 5.40997 -1.38762 -39.6682 22.4532 -169 1 1.10468 1.00284 9.3945 22.843 10.0615 -6.85845 -170 2 1.39907 0.698807 10.2625 -7.65597 -6.79115 6.92044 -171 2 0.213465 0.701839 9.27091 -15.6194 -8.53979 4.03703 -172 1 16.7947 2.33154 13.2859 2.87858 8.18604 -25.1476 -173 2 17.0129 2.55787 12.3417 -6.42954 -5.0835 25.2497 -174 2 16.4749 1.41822 13.3005 0.0523867 -3.46078 1.59731 -175 1 2.46566 15.827 12.1934 26.7468 -10.5365 13.2985 -176 2 2.93451 15.5288 13.0073 -9.90545 6.65681 -19.023 -177 2 2.95128 15.4495 11.4346 -3.9234 5.36807 1.6728 -178 1 16.4371 15.5461 5.94503 -4.66267 19.6238 -8.97399 -179 2 17.3612 15.5093 6.28134 -9.63254 6.93473 -7.38316 -180 2 16.3109 16.2991 5.29174 10.2179 -16.1602 20.4085 -181 1 5.84392 5.02209 11.7979 1.85982 -4.44524 -6.98506 -182 2 5.51366 5.87933 12.041 -2.35542 15.5447 8.97079 -183 2 5.10963 4.44446 12.0068 -1.26359 -10.5886 0.396425 -184 1 15.2223 4.8645 0.724291 -23.0156 -11.391 23.7803 -185 2 14.7624 4.52384 1.55825 21.1304 12.2284 -22.5635 -186 2 14.5125 5.05103 18.7394 0.751055 2.39009 4.23042 -187 1 16.343 16.2984 2.11648 10.3227 5.9227 -27.7144 -188 2 16.0112 16.8052 2.83865 -11.2354 10.0489 28.078 -189 2 16.6417 17.0002 1.51324 -1.84363 -9.29214 0.277829 -190 1 0.300695 4.8777 3.79796 -11.7144 38.8206 3.66766 -191 2 0.319109 5.88664 3.94702 6.24107 -45.2605 -6.61048 -192 2 1.15751 4.50056 4.01017 2.49534 2.82459 2.96224 -193 1 2.92353 14.9884 15.0405 10.7548 -7.33568 16.7257 -194 2 2.98085 14.609 15.9661 -8.47597 15.0336 -19.5599 -195 2 2.47925 15.8529 15.1074 -0.728265 -0.613609 8.13891 -196 1 1.11951 14.5697 9.5576 17.0302 46.4745 -20.2694 -197 2 2.08903 14.5584 9.38425 -20.4257 -12.3501 8.75388 -198 2 0.805573 13.7616 9.91809 5.52927 -28.6811 10.8766 -199 1 13.6617 16.6633 11.5459 -10.7506 10.3565 -21.4971 -200 2 13.3218 17.4276 11.0158 5.92664 -14.8533 17.3679 -201 2 13.3915 15.8986 11.0154 -3.11899 -0.859159 7.39997 -202 1 4.73366 1.47986 0.719369 -25.3145 -4.02421 3.51446 -203 2 4.15092 1.98399 0.125941 8.58395 1.79335 0.854136 -204 2 4.09918 0.853913 1.13528 12.7275 2.9151 -0.0185569 -205 1 1.42442 18.4742 11.9045 -6.93945 20.4545 -13.991 -206 2 1.2372 0.390371 12.6666 -0.822965 2.19478 3.53324 -207 2 1.89543 17.725 12.2367 7.95706 -17.4489 5.30436 -208 1 11.5469 10.1058 4.11116 26.1716 14.4711 -26.2735 -209 2 11.5284 10.5631 3.21886 -3.69376 -13.1884 23.9867 -210 2 12.5118 10.0773 4.36205 -26.1062 -0.534026 -7.20275 -211 1 8.37237 12.1712 3.75254 -13.3709 24.5961 46.1376 -212 2 9.17249 12.5936 4.11701 3.41223 -8.92861 -19.033 -213 2 7.75234 12.4533 4.48752 5.20668 -18.7884 -32.053 -214 1 14.3233 4.03204 3.29282 11.0049 6.10018 19.4579 -215 2 14.9517 4.19348 4.04461 -8.72763 -4.53117 -18.7735 -216 2 13.4979 4.46304 3.56838 3.12416 -1.49393 -3.31976 -217 1 5.58139 1.77074 7.50691 -36.613 -47.7339 30.604 -218 2 4.96189 1.1025 8.02564 35.7201 38.4984 -27.3817 -219 2 5.38779 1.57566 6.57729 1.13697 3.96791 -6.02851 -220 1 17.9042 1.1171 4.88471 6.84957 17.1887 -7.45832 -221 2 18.4571 1.56865 4.21188 -4.6905 -14.0516 5.22121 -222 2 17.737 1.81424 5.53024 -1.96776 -6.02251 3.4729 -223 1 6.82733 9.39684 4.48845 1.87187 -0.890058 -10.0607 -224 2 6.84716 9.53076 5.42818 -7.08772 5.76802 18.8049 -225 2 7.72364 9.08838 4.32443 4.93667 -1.85919 -9.57362 -226 1 2.70107 14.964 1.9632 9.79064 -8.50271 -23.1477 -227 2 3.33865 14.7342 2.63816 0.0868029 -0.794049 11.9475 -228 2 3.17782 14.7454 1.13419 -13.4 8.87294 12.5953 -229 1 17.2782 12.8964 13.1387 8.1593 -36.3772 6.82198 -230 2 16.3556 13.1177 13.3173 4.03584 18.7537 -2.31465 -231 2 17.8303 13.6552 12.9439 -8.38561 20.0322 -1.78655 -232 1 15.018 10.5797 1.38541 -30.6488 -33.8734 -22.7761 -233 2 15.5405 11.2097 1.82354 25.6355 33.1541 21.1587 -234 2 14.2986 11.0703 0.97193 1.92599 -0.723232 4.24038 -235 1 5.71261 6.94641 4.5266 2.6516 -23.4686 10.5302 -236 2 5.87991 7.88124 4.41392 4.1014 10.4162 -0.896017 -237 2 6.40034 6.62744 5.14459 -6.91809 0.316355 -6.72793 -238 1 8.10894 8.26231 10.1757 -1.61977 4.99166 17.0229 -239 2 8.63366 8.87039 9.65704 12.8257 12.1371 2.09156 -240 2 7.5873 7.82886 9.51802 -16.026 -14.2044 -11.4362 -241 1 13.5265 18.2929 5.80397 -22.7677 -1.43199 15.791 -242 2 12.744 0.210577 5.63003 6.52185 -0.137688 -2.34328 -243 2 13.224 17.7307 6.55929 8.82644 11.7072 -16.2211 -244 1 0.31998 2.55606 0.111337 -23.7151 48.4906 1.53453 -245 2 18.006 2.70756 18.6319 7.21623 -15.3908 0.76394 -246 2 0.639493 3.49242 0.214062 7.71863 -30.3236 1.31164 -247 1 12.6438 10.9651 9.76843 -27.6007 42.776 -15.0826 -248 2 11.6462 10.8587 9.68427 36.5826 -6.8361 3.61513 -249 2 13.0097 10.1328 10.024 -0.792921 -29.0746 6.76076 -250 1 0.78357 12.2825 11.0843 20.7577 -6.91251 -2.74458 -251 2 18.4749 12.2741 11.1385 -12.0685 2.84404 7.0736 -252 2 1.15918 12.6384 11.9096 -11.1326 -3.84191 -3.75479 -253 1 5.04379 7.22322 13.4829 1.39832 5.89977 -6.97466 -254 2 5.58123 7.93479 13.1271 0.448534 7.96016 -10.0051 -255 2 5.53384 7.00565 14.2746 1.03136 -7.66768 11.7435 -256 1 1.27874 6.97532 11.834 -32.074 -43.2189 -14.0481 -257 2 0.482678 7.18669 11.3131 10.1443 0.561183 6.98996 -258 2 1.70367 7.78255 12.0103 18.1825 36.8435 9.31001 -259 1 15.4541 9.47267 12.3132 5.88964 23.7827 6.22024 -260 2 15.5166 10.4677 12.3686 -5.40153 -30.7713 4.20372 -261 2 15.4815 9.07432 13.2056 -1.6395 12.2138 -11.1334 -262 1 16.6425 12.9485 5.45228 -24.7761 13.2233 -32.5849 -263 2 16.3124 13.8685 5.42836 11.1894 -7.98651 20.9726 -264 2 16.4187 12.7313 4.52305 11.1313 -16.3356 15.5726 -265 1 6.1733 10.0557 0.193027 -12.4899 -11.5053 -32.3049 -266 2 5.38495 10.4604 0.58061 6.43577 -0.470902 4.897 -267 2 6.88008 10.1049 0.827544 12.5305 3.42311 14.2724 -268 1 12.3659 6.05415 4.04188 -22.1763 -21.8278 15.5685 -269 2 12.3683 6.79715 3.46108 4.13216 24.0909 -16.7914 -270 2 11.421 5.79287 4.05326 15.4186 -0.211849 3.77561 -271 1 0.132582 12.8231 0.203992 -0.195483 1.63508 -4.90635 -272 2 -0.0245094 13.5503 0.825031 2.49545 -1.98409 0.771993 -273 2 18.2458 13.055 18.0666 5.13636 -1.5464 3.82803 -274 1 3.83888 18.5816 8.61379 -9.81831 -4.88162 -16.6552 -275 2 3.52001 18.2631 7.75085 8.43173 -4.7192 1.01067 -276 2 3.03206 0.305129 8.96677 -7.80256 7.43459 9.99927 -277 1 7.39556 17.2738 4.45596 16.9172 12.0122 12.5371 -278 2 7.99849 17.9848 4.79149 -15.6229 -16.9846 -19.2965 -279 2 7.33818 17.3251 3.48629 6.36463 5.57381 8.87833 -280 1 9.21998 17.0388 12.2284 15.8258 3.83046 11.207 -281 2 9.35195 16.1931 11.7423 2.16771 12.8413 7.7779 -282 2 10.0104 17.2216 12.8137 -16.5375 -11.854 -19.0408 -283 1 13.3184 13.0063 7.94019 -19.3301 -32.807 5.85066 -284 2 13.1883 12.2647 8.56801 -4.60418 3.91603 -7.64254 -285 2 14.1459 13.3708 8.19821 21.3317 21.1541 5.11013 -286 1 14.9844 2.95035 15.3504 8.07249 -1.73557 -24.8008 -287 2 14.3 2.40675 14.9389 -0.805511 -1.63288 7.60525 -288 2 15.6705 2.98762 14.6436 -9.05507 2.69068 16.8604 -289 1 9.85476 15.5033 17.004 5.70996 8.22456 -10.0233 -290 2 10.2769 14.6753 16.7296 0.407564 1.12786 2.5917 -291 2 9.2992 15.3275 17.7693 -4.49302 -4.18434 5.79618 -292 1 11.2887 8.25054 16.5462 4.3815 15.8935 1.4126 -293 2 10.7498 7.72178 15.9677 -11.4268 -3.01506 -11.0903 -294 2 11.7109 7.60541 17.1026 7.03572 -6.39426 11.2088 -295 1 3.78312 18.1923 16.7229 -8.20319 16.8802 -14.09 -296 2 4.23544 17.5706 17.2928 8.99584 -2.65396 14.876 -297 2 3.78517 0.451969 17.0887 5.65759 -16.2586 2.71634 -298 1 2.1977 4.10819 8.95021 24.5715 -13.8141 31.6135 -299 2 3.03624 3.61916 8.82088 -15.7399 12.2693 -11.2697 -300 2 2.14197 4.07166 9.94067 -11.3718 7.67499 -23.2123 -301 1 9.90974 10.3516 9.73776 -22.8793 37.5197 3.40937 -302 2 9.44348 11.1923 9.4561 16.1923 -27.4723 -0.755713 -303 2 9.93951 10.4177 10.7077 4.76489 -7.47333 -8.73237 -304 1 9.73601 0.810068 10.8572 -6.50885 -0.835519 -1.39877 -305 2 9.40585 18.6129 11.1735 2.22486 -11.7661 13.7712 -306 2 9.0915 1.01857 10.1847 -1.93261 14.5334 -11.6688 -307 1 9.19364 15.2092 10.2107 -23.0073 -10.2994 -8.74256 -308 2 8.9841 16.0542 9.76587 1.98806 -14.8547 5.4661 -309 2 8.35152 14.6762 10.1166 22.3916 12.2872 5.93767 -310 1 0.995532 9.29186 10.3281 47.9462 -2.63812 -8.64675 -311 2 1.22741 10.2031 10.5086 -13.3799 15.5027 2.96196 -312 2 1.9063 8.9262 10.1621 -35.7029 0.949407 3.82346 -313 1 16.813 4.88766 8.1932 11.5161 -10.5322 32.9144 -314 2 16.1615 5.34773 8.77307 11.8935 -6.11126 -18.0819 -315 2 17.4051 4.37395 8.80041 -19.6267 13.8505 -17.9411 -316 1 14.6429 14.6942 0.394535 -7.00543 -1.89626 8.24203 -317 2 15.0463 15.2494 1.09531 -2.64327 -9.316 -7.76003 -318 2 13.8679 14.2346 0.794348 15.878 11.3494 -8.58286 -319 1 3.51953 11.0524 9.63262 1.11689 7.20138 -8.56155 -320 2 3.49309 11.4422 10.5196 2.01858 0.130954 -3.30783 -321 2 3.17116 11.7397 9.0203 2.67149 -7.88535 6.47818 -322 1 11.039 10.8616 1.27104 8.39953 16.0658 -8.46941 -323 2 11.1885 11.6907 0.750788 0.782166 -19.893 14.3131 -324 2 10.1072 10.6419 1.14889 -0.773464 -1.49716 1.06219 -325 1 13.2204 7.07184 12.8933 -24.0174 5.01566 -6.09093 -326 2 14.1394 6.83939 12.9167 20.0602 -3.76028 0.39046 -327 2 12.7464 6.22555 12.8749 2.49778 2.97258 -0.29329 -328 1 9.62856 1.88969 0.946546 9.2636 -0.931103 20.1878 -329 2 8.76541 2.02695 0.593353 -22.3319 -0.80038 -4.92587 -330 2 10.1675 1.74594 0.181071 13.2226 0.132969 -11.6901 -331 1 10.5934 13.5316 4.73807 16.1446 0.574492 13.3086 -332 2 11.4317 13.0614 4.94174 -10.7106 3.3069 -14.0299 -333 2 10.5321 14.1207 5.51129 -4.24994 -4.20037 -10.3127 -334 1 14.2715 1.70318 10.8964 -1.77809 5.91235 7.28652 -335 2 15.0728 1.25501 10.5853 5.24738 9.35157 -1.74174 -336 2 14.4034 2.67095 10.8772 7.32957 -6.49183 -2.39775 -337 1 14.6603 12.4192 11.7243 1.91159 -25.2344 -56.6412 -338 2 15.4845 12.4874 11.1931 -4.23005 7.1619 22.5795 -339 2 14.0903 12.0081 11.0211 -1.48986 11.1607 31.5891 -340 1 8.24886 5.08654 9.79134 -29.2123 3.64284 23.7692 -341 2 7.42109 5.02927 10.3149 15.0309 17.1198 -4.03621 -342 2 8.23121 4.21184 9.43797 12.1669 -22.8524 -17.3047 -343 1 1.59528 16.8201 18.3251 -4.66834 32.7155 -7.23976 -344 2 1.93304 17.2062 17.488 -5.12416 -8.69561 13.5025 -345 2 1.82608 15.9028 18.3034 8.21551 -19.1337 -3.40609 -346 1 1.44054 17.2474 15.3375 38.2305 -7.16391 -6.50211 -347 2 1.35107 18.1379 15.6308 4.79859 24.8425 9.12518 -348 2 0.562777 16.9452 15.3387 -39.5261 -18.284 -3.02502 -349 1 3.72855 5.57524 6.20331 -9.94128 10.6794 2.05156 -350 2 3.21297 6.20603 6.76334 9.83918 -6.42931 -13.7589 -351 2 4.29894 6.06824 5.5848 -3.89827 7.08279 4.15512 -352 1 12.3545 9.42683 14.1827 20.4014 -41.9092 8.4814 -353 2 12.8623 8.59837 13.88 -21.4785 35.8512 3.66034 -354 2 12.0611 9.1345 15.077 2.36507 11.6403 -12.9904 -355 1 4.03327 15.2744 6.905 24.5442 3.45717 -5.69457 -356 2 3.46314 16.0225 6.67296 5.01039 2.15408 -3.12402 -357 2 4.97164 15.5268 6.67147 -27.9532 -4.4537 7.17357 -358 1 0.606997 8.56433 14.8637 1.00605 -0.185347 4.59471 -359 2 0.51054 9.52697 15.0006 4.18475 -5.95105 -3.81642 -360 2 1.25745 8.45601 14.1476 -5.10421 5.72757 5.73964 -361 1 12.9756 8.36618 10.3398 20.3701 -17.1189 -10.5242 -362 2 13.727 7.8435 10.0036 -6.14808 8.99881 -11.6124 -363 2 12.9675 8.02293 11.2263 -11.3517 2.56625 21.5008 -364 1 15.2884 7.63693 3.49378 10.1588 18.7913 -12.1111 -365 2 14.5458 7.1482 3.08376 7.93209 -0.245397 21.6039 -366 2 15.5211 7.50792 4.43838 -15.1505 -14.5868 -6.72816 -367 1 17.3202 6.64717 0.0328861 -29.9623 13.6257 -2.83905 -368 2 16.7745 5.97673 0.482414 9.93705 -0.647346 -3.81794 -369 2 16.6178 7.22121 18.2734 18.8696 -9.84661 9.86066 -370 1 8.80495 6.92785 7.84504 -31.0915 -18.6038 9.28479 -371 2 9.6769 7.2872 7.80779 30.3288 7.87046 2.96903 -372 2 8.72406 6.35246 8.64105 6.6093 9.83872 -10.9319 -373 1 12.3211 0.614363 1.17365 13.0662 -3.77868 -0.487657 -374 2 13.0766 0.983141 1.64654 -0.239842 1.32967 3.5541 -375 2 12.751 18.5673 0.657414 -10.2946 0.778432 -2.83622 -376 1 5.67951 15.1028 14.5131 10.9467 16.6442 -3.65569 -377 2 4.71936 15.1727 14.6088 -3.18386 3.297 0.861488 -378 2 6.03308 15.9436 14.1233 -11.409 -15.106 9.73801 -379 1 3.83531 6.52602 1.68735 -5.34791 11.2881 1.09554 -380 2 3.46655 7.33088 1.27913 5.03876 -12.3281 -3.02901 -381 2 3.83759 6.80671 2.60341 5.67562 -6.55284 8.9174 -382 1 3.89065 11.6139 12.2421 9.17745 -10.34 -2.42323 -383 2 4.7546 12.041 12.3761 -4.43478 1.7756 4.32079 -384 2 3.22616 12.1252 12.7041 -4.55935 10.4369 8.15325 -385 1 5.44913 3.8771 15.872 6.89679 52.3696 13.3559 -386 2 6.00532 3.19945 15.5174 15.3476 -19.3003 -7.67953 -387 2 6.04432 4.69577 15.9682 -27.8341 -34.2187 -5.04159 -388 1 14.46 10.319 4.39654 9.99722 -28.3378 -34.0856 -389 2 14.8446 9.82936 5.13517 -3.65574 0.244774 4.37558 -390 2 14.7053 9.78242 3.56924 -11.9433 24.8074 33.8136 -391 1 7.944 17.2975 9.23787 -28.0002 30.4191 -3.50914 -392 2 7.19679 17.6006 9.79194 10.1387 -11.5361 -1.79961 -393 2 7.93806 17.9436 8.50883 9.12371 -8.84918 -0.989999 -394 1 4.50274 14.4265 3.96251 25.8442 16.5744 44.5421 -395 2 4.82189 15.3364 4.24204 -15.9069 -22.6382 -13.9696 -396 2 4.78076 13.8411 4.72747 -13.1976 12.376 -28.3375 -397 1 14.3227 7.38582 15.7589 14.6846 6.74467 9.8564 -398 2 15.2487 7.24382 15.4614 -20.8339 3.06086 7.28672 -399 2 14.432 7.78597 16.648 -5.3607 -7.66211 -14.83 -400 1 2.87305 18.2228 1.9038 16.9424 31.4889 37.3817 -401 2 2.5254 17.6641 1.24513 -20.0746 -27.9737 -30.7942 -402 2 2.12041 18.5329 2.44243 8.04928 -1.15784 -8.26421 -403 1 7.96513 1.6038 4.534 28.375 12.0389 1.8382 -404 2 7.4881 1.94169 3.78174 -16.4915 0.831655 -6.1583 -405 2 8.81315 2.08427 4.47067 -11.0504 -12.9149 7.37414 -406 1 2.66628 14.1304 17.7551 -36.5802 -20.3813 5.76686 -407 2 1.82799 13.6385 18.0009 26.1666 13.51 -7.41699 -408 2 3.38829 13.5766 18.1016 -3.21353 7.84202 -3.40779 -409 1 0.72398 1.68558 13.861 19.6061 1.62564 -3.20216 -410 2 0.832024 1.51571 14.7895 8.81281 -5.19825 13.648 -411 2 18.448 1.87896 13.7961 -22.7247 6.41229 -8.76432 -412 1 4.5528 18.6039 13.9643 16.282 -5.93943 -10.6264 -413 2 5.43228 18.1791 13.8337 -18.6035 11.3559 2.42201 -414 2 4.30609 18.3878 14.8696 -5.35687 -0.29015 4.72759 -415 1 7.10471 0.475722 18.3652 -9.95344 30.3778 33.8159 -416 2 7.09526 0.10374 17.5021 -2.11792 -9.18089 -28.9852 -417 2 6.24907 0.928295 18.5508 11.5399 -12.8337 -6.73806 -418 1 16.1003 18.4419 14.1295 -36.1288 -26.1963 -8.72431 -419 2 15.3858 17.8107 13.8537 25.0074 20.4613 -2.43664 -420 2 15.9155 18.5409 15.0697 10.6475 8.10349 1.05551 -421 1 10.1087 4.51964 16.2872 -49.6317 2.46368 -20.184 -422 2 10.9899 4.47274 16.5903 35.3659 -6.27505 9.52333 -423 2 9.84839 3.65208 15.9265 12.032 5.89647 9.33422 -424 1 15.84 17.9245 4.41355 -16.3771 8.07859 19.8211 -425 2 16.4973 18.6399 4.5293 -6.75294 -6.64677 -2.2152 -426 2 15.0245 18.216 4.92863 29.2279 -12.5546 -21.8691 -427 1 6.93052 17.3604 13.733 43.7573 11.6301 8.94285 -428 2 7.46287 17.7112 14.5144 -20.3873 -12.0805 -21.5216 -429 2 7.61723 17.2481 13.0216 -16.2109 2.19972 16.1164 -430 1 13.284 6.56612 6.73549 -17.3988 -10.9235 -13.9284 -431 2 14.2147 6.66272 6.66556 31.8926 9.42178 10.838 -432 2 13.0817 6.39483 5.81333 -16.4457 -2.73061 -4.18006 -433 1 7.68008 2.38704 9.18412 -10.173 -8.0052 -21.8631 -434 2 7.24249 2.31281 10.0234 -2.88588 -0.126179 20.3224 -435 2 6.98126 2.1061 8.54708 21.029 6.80491 7.05088 -436 1 15.1532 14.8723 13.6487 -17.4978 4.30428 5.82091 -437 2 15.0143 15.0659 14.5909 6.59258 -1.67926 -7.31154 -438 2 14.3234 15.1254 13.2077 14.4343 -4.04757 1.78875 -439 1 9.30028 8.33456 3.70705 10.2977 -8.98362 5.75949 -440 2 10.1463 8.82212 3.80538 -6.03443 -8.47657 3.00821 -441 2 9.47356 7.38745 3.89392 -0.00834887 14.0135 -2.32863 -442 1 17.6906 13.477 16.4461 19.9282 13.2905 -5.82842 -443 2 16.7369 13.3711 16.3792 -1.87427 5.41308 -4.03884 -444 2 17.9311 14.3351 16.016 -12.453 -14.9372 6.18952 -445 1 5.04349 10.6567 2.59903 16.1191 -13.6813 18.2195 -446 2 5.79495 10.2927 3.12129 -13.5181 3.52014 -12.0414 -447 2 4.57705 11.1773 3.24438 -8.0447 10.2459 5.04269 -448 1 3.70971 8.35842 10.3252 1.44092 -18.6834 3.58878 -449 2 3.85247 9.29033 10.1825 3.16815 17.7869 -8.4001 -450 2 3.85129 8.23256 11.2753 -2.11366 -0.888936 -6.9574 -451 1 16.1019 7.11228 6.32302 5.1556 -18.0856 -12.5793 -452 2 16.7603 7.67894 6.76117 -3.13697 -10.0137 -6.06994 -453 2 16.5199 6.22503 6.17941 -9.70023 19.4355 5.8489 -454 1 15.1873 7.00993 9.1119 -0.598311 32.9952 -33.7165 -455 2 16.0219 7.38603 9.44635 -11.3494 -6.74009 0.758637 -456 2 15.0255 7.54922 8.27157 3.37955 -23.1281 33.9738 -457 1 6.44391 13.1496 12.9059 -4.52757 0.45998 7.29234 -458 2 7.24313 12.6736 13.1625 -0.99472 -4.48021 -2.73775 -459 2 6.29798 13.7908 13.6311 -2.25413 -7.45453 -16.6836 -460 1 12.1229 4.49714 13.069 31.9377 20.6864 19.2416 -461 2 12.2438 4.59516 14.0263 7.18846 6.47209 -3.71556 -462 2 11.355 3.98337 13.0276 -40.2556 -25.9573 -14.351 -463 1 11.341 8.18871 7.85243 -8.78275 4.89867 3.16356 -464 2 12.019 7.65272 7.40248 3.56578 3.50389 11.6767 -465 2 11.6495 8.4222 8.75253 4.0122 -9.00416 -11.7002 -466 1 17.1801 10.777 7.4192 7.36201 -8.80257 6.42916 -467 2 17.8272 10.0453 7.20283 -14.4353 25.3005 -3.23105 -468 2 17.1099 11.4706 6.73084 6.53972 -12.3853 -1.04707 -469 1 5.23123 18.1422 11.0533 -19.2518 -11.1169 -0.556795 -470 2 4.68428 18.0818 11.8689 9.03658 -0.237539 -15.4649 -471 2 4.66385 17.8138 10.3113 13.0077 11.3369 14.9543 -472 1 7.56693 17.6215 1.82415 1.62007 -3.46367 5.28784 -473 2 7.78898 16.8334 1.34681 6.63524 -26.0188 -1.32905 -474 2 7.45125 18.2129 1.09256 -3.64481 20.3372 -5.96154 -475 1 1.86389 12.9287 13.6093 11.2123 10.389 11.461 -476 2 1.60858 12.3493 14.3514 0.368407 5.87334 -8.62616 -477 2 2.19533 13.7617 14.0254 -8.04715 -19.4049 -4.74077 -478 1 9.73211 6.79545 14.8053 -13.3635 29.1677 -1.2594 -479 2 9.95388 5.9401 15.1198 6.74212 -35.5267 16.6171 -480 2 9.99758 6.80472 13.8879 2.87601 5.55808 -10.3757 -481 1 15.2079 4.3816 10.7747 2.87683 -10.6846 -6.34453 -482 2 16.1141 4.09829 10.8354 14.0041 -14.4682 -8.99775 -483 2 15.2413 5.10857 11.3759 -13.982 19.572 13.657 -484 1 11.1943 6.12299 0.161942 7.30858 3.38886 3.78771 -485 2 11.3169 5.17116 0.363074 -11.79 12.5462 -9.55941 -486 2 10.2709 6.35961 18.5708 8.1781 -12.6509 6.67443 -487 1 0.185288 11.3311 15.1365 -30.887 25.32 -22.6423 -488 2 18.3259 11.8316 14.411 15.9364 -20.9841 19.9458 -489 2 18.5436 11.8171 15.9275 6.31494 -1.3813 -2.75882 -490 1 7.07253 9.14554 7.26503 -12.8693 -9.44748 7.54332 -491 2 6.53496 8.39024 7.60511 8.01051 18.2562 -7.56901 -492 2 7.96025 8.78683 7.22728 5.66006 -0.214789 -0.295522 -493 1 18.4466 15.4455 12.3524 0.715601 -5.5542 4.25712 -494 2 0.765537 15.5739 12.2932 -9.35503 -1.07101 -3.81958 -495 2 18.1041 15.6865 11.4834 1.82716 1.84183 -0.0676895 -496 1 16.5728 4.36435 5.2485 -25.4993 -8.29978 29.4912 -497 2 16.6816 3.92322 6.14286 5.98391 16.1522 -30.7717 -498 2 17.375 4.39451 4.72672 17.8313 -3.46111 1.89189 -499 1 17.7791 3.0704 10.7152 16.7916 7.15275 7.98838 -500 2 0.0816242 3.14072 10.966 -13.8603 5.05813 -1.71981 -501 2 17.7027 2.20602 10.3066 -7.17166 -8.4112 -5.21368 -502 1 12.3075 0.0618611 10.1685 -8.15907 17.9474 -0.312818 -503 2 11.3684 0.344551 10.3468 27.9971 -1.27027 -0.956139 -504 2 12.8942 0.865557 10.2681 -22.4015 -23.39 -3.54403 -505 1 10.3613 9.82386 12.3172 12.1455 12.129 19.7304 -506 2 11.1427 9.8808 12.9129 -10.2174 -2.53791 -7.09814 -507 2 10.1997 8.88396 12.252 -0.966331 -12.4705 -0.927319 -508 1 0.481536 2.83002 7.02126 3.70324 23.8076 -10.0458 -509 2 0.770856 3.62826 7.51109 -3.83076 -19.2444 -0.666321 -510 2 0.694466 2.06428 7.55035 5.7415 -3.83046 10.8422 -511 1 0.467049 15.2425 6.91705 -4.45928 -38.0226 -11.2702 -512 2 0.600151 15.6263 7.78281 2.30728 -6.41275 13.0317 -513 2 0.61271 14.2361 7.00049 -2.84554 47.7716 -5.16909 -514 1 16.9541 7.01237 15.3291 23.6374 -7.48971 -3.1828 -515 2 17.7457 7.53254 15.1705 -1.99719 18.034 -6.10418 -516 2 17.38 6.19105 15.5941 -13.3003 -10.4743 0.120416 -517 1 9.01017 12.4224 8.1441 -46.2717 9.6088 -11.1501 -518 2 9.26268 11.8248 7.45061 25.2615 -14.9445 -10.6927 -519 2 8.05034 12.5239 7.91838 26.5695 6.53823 20.3475 -520 1 1.26455 1.94093 3.05316 3.58571 9.71968 -12.011 -521 2 1.22461 2.59742 2.34045 -8.12686 -11.986 1.71554 -522 2 1.93366 2.31359 3.63129 0.35358 -2.72116 4.87465 -523 1 4.13309 15.1146 9.63821 -4.623 1.46382 -0.938733 -524 2 4.12694 15.148 8.67475 -7.89004 5.45838 -0.100118 -525 2 4.98588 14.7259 9.81048 11.3537 -4.87926 10.963 -526 1 7.17766 2.17952 14.5652 7.62536 9.73749 11.0593 -527 2 6.96972 1.69872 13.7643 -0.327528 -0.451328 -7.35604 -528 2 7.66158 2.98182 14.3072 -3.86315 -8.18785 -0.50787 -529 1 18.6094 14.7115 2.1553 18.1066 -29.4746 -3.14947 -530 2 0.852094 15.108 2.23259 -6.38197 3.09186 -0.259441 -531 2 17.9366 15.3527 2.32074 -15.2526 23.2774 3.26778 -532 1 9.94663 2.7868 12.9455 2.69617 -13.1789 -11.1834 -533 2 9.77369 2.19316 12.1903 7.43131 1.21406 6.14773 -534 2 9.20096 3.38667 12.9408 -6.30409 9.38042 4.37845 -535 1 2.80852 8.91644 13.0153 -16.8956 -9.28674 -0.0207487 -536 2 3.13809 9.78934 12.8448 9.36486 20.7895 -4.33486 -537 2 3.52774 8.43066 13.407 13.2058 -10.3846 6.75792 -538 1 3.23128 8.35577 3.63883 6.10249 8.71431 60.2633 -539 2 3.54401 9.08838 3.13137 7.96401 15.5303 -21.3649 -540 2 3.46232 8.64756 4.58519 -13.4978 -19.9669 -35.5279 -541 1 5.63324 7.19832 8.5125 -13.133 -10.0414 6.96154 -542 2 5.51092 6.25688 8.34615 12.8941 -5.44374 -4.51219 -543 2 4.92213 7.36133 9.14092 2.83191 13.4678 4.26874 -544 1 14.878 1.27944 2.0109 -7.35803 -30.2596 -13.1701 -545 2 14.8616 1.98275 2.64555 4.54601 24.3613 2.83628 -546 2 15.264 1.50064 1.14913 0.22226 12.7122 6.62367 -547 1 8.2353 15.1956 0.84899 9.2054 13.6294 -15.3468 -548 2 9.04355 15.0937 1.38227 -7.5254 -5.87742 4.76726 -549 2 7.50355 14.6763 1.20804 4.58246 -4.32042 7.88142 -550 1 15.6328 1.34461 7.23795 -19.9173 -11.1245 -9.46976 -551 2 14.9591 0.718796 6.85982 16.5955 19.1651 8.9454 -552 2 15.1508 2.16575 7.45752 1.02199 -7.71962 -3.30529 -553 1 4.91374 13.0908 18.526 15.2565 -4.60213 14.3208 -554 2 5.33439 13.1154 0.77269 -6.07604 1.59812 -16.6926 -555 2 5.51105 13.5936 17.9543 2.83588 -2.74206 0.160853 -556 1 15.3493 8.4742 18.1502 12.1518 9.73195 -18.1744 -557 2 15.7592 9.1135 17.5088 -10.0207 -13.011 16.7995 -558 2 15.2243 8.95162 0.336167 -0.033387 6.18709 -0.40176 -559 1 12.0721 3.03363 18.372 7.89134 -10.3745 2.1206 -560 2 12.0185 2.56449 0.551271 -8.88822 8.03447 17.3967 -561 2 12.5632 2.36483 17.898 4.02516 4.57474 -24.0136 -562 1 13.2076 12.6757 5.17908 4.47921 -5.37266 1.03993 -563 2 13.7293 11.9632 4.79272 -2.12471 -1.88137 -7.76598 -564 2 13.3867 12.5644 6.11349 -3.52883 8.17381 9.78336 -565 1 6.04737 7.04753 0.0353989 10.049 -23.447 -5.31085 -566 2 6.01346 7.99319 18.6275 -7.37118 27.2698 7.20756 -567 2 5.32085 6.74358 0.593628 -6.10646 3.40609 1.47388 -568 1 17.7373 16.0235 15.0083 12.9173 -11.5355 46.7271 -569 2 16.9426 16.5159 15.2406 -3.68569 -0.0523083 -17.9381 -570 2 17.9142 15.8937 14.0864 -12.7219 4.58342 -31.2732 -571 1 13.1912 1.0014 16.5506 10.6966 -14.1722 10.2872 -572 2 14.1553 0.911674 16.6931 -11.9901 3.10273 -3.01829 -573 2 12.8874 0.074803 16.5753 -2.30324 8.04411 -4.14072 -574 1 11.1133 14.5665 7.20897 13.0955 23.3619 -16.6223 -575 2 10.3963 14.2935 7.74934 -21.4591 -15.3449 18.7975 -576 2 11.8402 13.9563 7.34501 4.8973 -5.05394 6.63835 -577 1 17.5096 8.63113 2.08657 0.966478 12.3426 12.6691 -578 2 16.6632 8.50317 2.50987 -10.5053 2.55961 10.3047 -579 2 17.5113 7.91267 1.47949 7.23292 -21.4893 -25.4513 -580 1 12.353 7.99884 2.01581 -2.70101 10.6364 -12.6504 -581 2 12.1945 8.88312 1.63494 1.68617 -6.44935 12.5501 -582 2 11.9639 7.41552 1.35659 -1.58766 -9.18843 -2.08326 -583 1 11.8879 14.6194 10.3406 -20.0746 -33.6598 -22.8547 -584 2 12.0361 13.784 9.8263 4.17148 28.2224 18.5196 -585 2 10.9018 14.6878 10.3309 21.6541 8.7111 3.83339 -586 1 6.88836 7.04362 15.6058 16.1194 20.5136 16.4981 -587 2 7.8035 7.27617 15.3369 -14.4637 -10.2261 -3.41305 -588 2 6.75267 7.59066 16.4113 -4.12685 -13.7627 -18.0291 -589 1 8.00073 4.72844 13.473 32.6072 13.4681 12.0072 -590 2 7.24466 4.78195 12.9199 -26.1194 -0.34176 -19.7698 -591 2 8.43099 5.60279 13.3668 -6.56701 -17.694 4.3215 -592 1 13.409 12.181 14.2619 -2.29334 -12.519 -3.59046 -593 2 13.0674 11.2691 14.1939 2.47622 3.528 5.79283 -594 2 13.8091 12.3245 13.3914 2.14013 7.29019 1.49174 -595 1 14.8335 9.42126 7.30208 -1.23415 -9.7028 -7.755 -596 2 15.6553 9.87909 7.43544 15.0677 5.06613 0.278043 -597 2 14.1895 10.0298 7.62302 -19.0881 6.3544 7.09879 -598 1 12.6523 17.0615 3.07749 -9.63712 20.8437 4.73829 -599 2 12.9489 17.4748 3.92954 -9.59054 -7.90452 -22.4084 -600 2 12.0211 17.6908 2.6147 24.5964 -20.1603 22.3384 -601 1 1.16316 7.14216 17.4575 -7.53687 9.98877 -12.7143 -602 2 0.304551 7.18474 17.9202 3.89796 -5.88799 -6.19513 -603 2 1.03245 7.53978 16.5617 1.30151 -5.77621 16.2427 -604 1 12.7701 5.15004 15.6505 19.6392 -10.8067 9.95473 -605 2 13.4563 4.50157 15.9538 -13.2351 19.2956 -11.0391 -606 2 13.2014 6.03319 15.6187 -0.0564141 -13.897 1.41482 -607 1 2.5292 3.39223 4.98971 -11.294 24.8894 43.5462 -608 2 1.79321 3.13497 5.63732 25.431 9.26734 -19.6171 -609 2 2.95221 4.24201 5.36402 -18.0427 -37.3772 -14.0443 -610 1 8.3195 11.2975 13.4498 34.4282 -42.0873 60.0692 -611 2 8.53145 10.9623 14.3727 -32.5783 27.093 -24.5589 -612 2 9.06913 10.8398 13.0623 -1.46455 6.72769 -32.5395 -613 1 12.8789 1.33599 13.3369 -0.326833 21.0111 -2.4484 -614 2 13.4114 1.42549 12.5087 -12.3149 4.19021 14.3531 -615 2 12.3728 2.16885 13.5095 17.1543 -18.8215 -15.124 -616 1 6.3438 13.6989 2.14861 -9.76603 2.4566 0.239062 -617 2 5.66699 13.9965 2.80165 17.5467 -9.19207 -8.6938 -618 2 6.94024 13.0708 2.57673 -0.273551 -0.649347 7.27334 -619 1 15.9211 6.60722 12.7931 -16.6599 -18.553 -4.38331 -620 2 16.3967 7.19214 12.2261 12.0088 12.5524 -15.4249 -621 2 16.3823 6.6241 13.6257 5.92705 1.19016 14.7721 -622 1 16.8355 0.712467 9.59592 -3.36362 -23.3789 -3.56206 -623 2 16.7779 18.376 9.75078 1.74957 20.9638 -0.413143 -624 2 16.4581 0.840534 8.70411 1.17104 2.38037 5.50581 -625 1 6.14488 11.7511 8.38011 -0.18946 -41.167 -3.37934 -626 2 5.27459 11.5011 8.78729 18.3987 2.85732 -10.3128 -627 2 6.60987 10.8879 8.11154 -22.1828 30.5528 10.1053 -628 1 2.89693 8.62105 0.44295 -56.4203 1.00956 -31.5069 -629 2 2.27197 8.22062 18.4324 34.822 -7.67477 5.45833 -630 2 2.23776 9.23156 0.789096 17.398 15.3469 20.296 -631 1 10.1637 10.4615 6.50349 -4.04384 3.34709 -8.13679 -632 2 10.5967 9.72069 6.94847 1.64295 -0.870339 0.249421 -633 2 10.4974 10.4621 5.5852 -1.057 -0.999308 12.8758 -634 1 6.73224 15.6973 6.55436 -2.09809 -5.48823 4.73835 -635 2 7.11043 16.1412 7.33204 2.41282 1.16671 -8.98558 -636 2 7.01002 16.1566 5.74315 2.18916 7.51026 7.17736 -637 1 6.44608 13.1679 5.58195 -4.20705 -14.9444 9.79279 -638 2 6.65412 13.9682 6.06813 3.08652 7.67851 0.170606 -639 2 6.07667 12.5708 6.24938 0.761343 1.39557 -4.00611 -640 1 16.8208 12.5604 9.84104 -2.42329 -13.6856 -22.0974 -641 2 16.9708 11.9197 9.11347 0.32984 0.887075 14.5477 -642 2 16.637 13.3652 9.35916 0.987515 11.3295 4.43609 -643 1 6.04174 2.95051 2.84722 -0.719082 -29.0389 17.5165 -644 2 6.39757 3.79665 2.63265 6.28437 26.7212 -14.5644 -645 2 5.5959 2.56013 2.08759 -0.264068 2.45464 -11.4985 -646 1 10.912 3.32579 3.30021 -11.54 -3.72468 -0.286686 -647 2 10.265 3.99241 3.57025 6.99069 0.708994 3.18227 -648 2 10.4899 2.90229 2.54711 3.22659 -3.75767 -5.68185 -ITEM: TIMESTEP -20 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.70913 7.06604 17.9499 1.08039 -7.3052 -10.6944 -2 2 7.76309 6.93671 18.0927 2.86377 -0.0634365 6.14939 -3 2 8.89082 6.62218 17.113 -0.435012 1.17195 3.96762 -4 1 18.5701 8.27154 6.84569 7.63886 -4.25596 16.0618 -5 2 0.0770478 8.01704 5.94511 2.80666 -2.10014 -27.175 -6 2 0.448594 7.6266 7.34851 -2.05713 5.96795 6.45131 -7 1 8.39922 18.5714 6.82203 6.72948 10.2859 -1.45868 -8 2 9.32775 0.155905 6.65662 -6.00666 -1.87083 0.283604 -9 2 7.88802 0.6421 6.41318 2.19693 -3.22314 0.641978 -10 1 6.59462 1.83749 11.6886 4.57701 1.91935 4.50468 -11 2 5.92153 2.26167 12.2253 -5.29818 6.79114 -2.36061 -12 2 6.2022 0.990271 11.4833 -4.39091 -13.1588 -5.35683 -13 1 7.12455 5.7334 2.35273 -30.6289 32.8622 11.4294 -14 2 6.61502 6.28908 3.00258 14.1285 -25.9969 -7.59408 -15 2 6.93422 6.24286 1.54682 10.1555 -14.3812 -3.81516 -16 1 16.2065 10.1646 16.1262 8.40668 11.1152 -6.07805 -17 2 17.0895 10.2474 15.7446 -2.7739 -5.15617 3.84543 -18 2 15.9438 11.0841 16.2665 -7.12418 -3.1551 3.11568 -19 1 10.6155 14.9936 2.32061 -1.92123 -0.42827 -4.10202 -20 2 10.587 14.5409 3.17342 -1.90113 -4.17135 2.45193 -21 2 11.1106 15.7965 2.49753 3.42935 4.58062 3.08668 -22 1 17.1538 8.25609 10.4362 5.05968 0.945942 4.2849 -23 2 16.7065 8.97876 10.9029 -1.41924 -5.56537 3.25582 -24 2 18.0123 8.61559 10.168 -2.45464 0.72557 0.389593 -25 1 14.8661 15.8683 16.3562 3.75833 -10.1031 -0.407994 -26 2 13.9609 16.1531 16.2809 -17.2441 8.84265 -1.93831 -27 2 14.8525 15.2671 17.1114 5.79928 3.60638 8.20478 -28 1 12.159 13.3907 0.439783 -6.21112 9.36015 -5.49833 -29 2 12.0312 13.5738 18.1447 5.07318 -6.56614 -2.93527 -30 2 11.6434 14.08 0.875998 -3.18612 -5.19303 11.2101 -31 1 9.2695 5.40921 4.0396 -15.9764 -20.2303 6.13461 -32 2 8.8083 5.02157 4.82949 8.30048 18.0685 -17.5094 -33 2 8.61456 5.30675 3.30783 11.5288 9.4755 11.0493 -34 1 1.82939 4.25621 11.6493 -6.71206 2.38393 -0.709376 -35 2 1.74358 5.20905 11.8686 0.595776 -11.527 -1.23597 -36 2 2.30823 3.82152 12.3665 0.967745 0.8605 0.134832 -37 1 1.98223 6.83069 8.36497 -5.35455 0.0641687 -19.1444 -38 2 2.41924 7.2303 9.11786 5.68758 -2.51321 7.89524 -39 2 2.03012 5.87061 8.47368 0.241822 -0.370612 9.81388 -40 1 5.39801 4.40718 7.93771 10.9733 2.82986 12.12 -41 2 5.47637 3.44759 8.05616 -6.09239 2.90192 -10.948 -42 2 4.7514 4.61131 7.25273 -1.49389 -3.85519 0.176314 -43 1 3.26825 2.92232 17.539 -14.9988 14.8633 6.4114 -44 2 3.91862 3.43305 17.0175 -2.74895 -4.28964 2.11315 -45 2 2.69145 3.57031 18.023 20.6758 -7.505 -11.8237 -46 1 7.47034 5.2735 6.10589 -2.49502 5.37071 -3.04547 -47 2 7.84271 5.98269 6.68437 -5.78386 -20.7203 -0.884416 -48 2 6.94663 4.6123 6.60405 7.6241 17.9385 5.03136 -49 1 9.77266 7.01281 11.9821 10.4665 -1.38292 10.7277 -50 2 10.3585 6.42202 11.517 6.59042 -6.6592 -2.49871 -51 2 9.12807 7.25863 11.3259 -16.7919 6.8996 -8.63143 -52 1 14.096 3.56038 8.06303 -5.03459 -1.11151 -11.1946 -53 2 13.7156 4.24767 7.5046 0.899669 0.845681 1.92473 -54 2 14.4812 4.01512 8.80943 2.7486 3.89851 9.64387 -55 1 4.73966 17.2567 4.00996 -0.195125 14.326 -18.5317 -56 2 5.55163 17.7707 4.1353 -4.1295 -8.09403 5.71009 -57 2 4.38972 17.5915 3.15482 -7.00181 -7.87351 15.3992 -58 1 16.5025 16.6092 10.0733 13.1432 9.20378 8.07617 -59 2 15.9712 16.6856 10.8668 -9.96451 -5.5735 1.54085 -60 2 15.9848 16.1464 9.41138 -7.70063 -5.20479 -0.44901 -61 1 1.97052 4.91045 0.450899 1.06366 9.69844 4.9192 -62 2 2.61093 5.33981 1.06219 -5.49885 -10.5105 -8.09306 -63 2 1.57388 5.6737 18.6422 7.70456 -7.85061 -0.972244 -64 1 11.7662 13.3441 16.2815 -7.88535 5.38496 10.7421 -65 2 11.2704 12.5109 16.442 6.50023 4.10664 -10.6094 -66 2 12.3479 13.2575 15.5066 -9.92493 -12.14 1.82083 -67 1 10.1201 11.0576 16.9389 3.39974 -19.6625 0.923124 -68 2 10.5319 10.1651 17.0061 -5.17122 15.3709 -2.15755 -69 2 9.17725 10.8754 16.8052 5.13113 2.71984 -2.06215 -70 1 11.7111 17.5152 13.4588 11.325 -2.75861 -1.19784 -71 2 12.3718 17.1152 12.8813 -0.632983 -4.36671 1.26506 -72 2 11.9961 18.4406 13.4806 -4.40298 2.90056 2.38202 -73 1 6.35795 9.30394 12.2283 8.95317 6.42027 -9.35456 -74 2 6.91663 9.09838 11.465 -5.59359 -11.5346 -0.139091 -75 2 6.8458 10.0391 12.6013 -0.320164 5.49925 11.3434 -76 1 16.2195 12.7457 2.69542 0.295574 -29.3957 1.13627 -77 2 17.0216 13.1501 2.38091 9.97003 13.3951 -1.47132 -78 2 15.5842 13.4209 2.91145 -9.8096 20.1499 -2.69183 -79 1 0.634077 12.5728 5.88372 -7.9484 2.86768 -4.89493 -80 2 0.988616 12.3569 5.00851 -6.1101 5.76055 1.83916 -81 2 18.334 12.7959 5.71409 15.811 -6.64636 4.43625 -82 1 5.2077 16.407 18.4749 -9.68849 -0.552221 -6.28119 -83 2 5.84718 15.7794 18.0984 2.41425 5.32286 5.94338 -84 2 5.56586 16.8292 0.618687 8.26881 -4.78153 -1.34873 -85 1 0.531249 7.63213 4.08542 33.6963 23.9515 -16.2824 -86 2 18.6021 7.94352 3.35108 5.75308 0.311196 11.7347 -87 2 1.44781 8.03396 3.8909 -38.1012 -20.2476 4.98268 -88 1 3.13519 8.90219 6.5128 -18.1806 -1.10975 19.7922 -89 2 3.61721 8.66647 7.3217 -0.167991 0.711605 -10.7948 -90 2 2.18954 8.88363 6.78472 17.5501 0.713198 -9.35234 -91 1 7.30642 10.3086 16.1993 0.33826 1.86993 11.5423 -92 2 6.5825 10.5097 15.5962 -1.40069 -1.74837 7.12047 -93 2 6.94436 10.2588 17.1142 -3.68695 0.804433 -15.344 -94 1 11.1033 1.05136 4.99998 6.51415 -6.68887 15.4104 -95 2 11.3804 1.86173 4.55399 -8.93638 -1.72916 -9.27788 -96 2 10.7652 0.40817 4.35737 0.804793 8.53975 -5.36269 -97 1 4.41906 2.71829 13.1993 1.75265 -17.8891 31.6776 -98 2 4.61925 3.15892 14.0364 2.0928 12.2335 -7.50334 -99 2 4.34595 1.79439 13.5397 -3.31279 7.49147 -22.0731 -100 1 8.39429 10.0534 1.8011 7.989 6.96853 5.58503 -101 2 8.43083 10.7556 2.48299 -4.47719 -6.35615 -3.34103 -102 2 8.76263 9.25633 2.22388 -6.49712 6.95404 -2.63041 -103 1 10.5097 1.74962 15.5619 -18.3761 -0.922722 7.55335 -104 2 11.4225 1.47346 15.6803 4.80494 4.8298 -6.32182 -105 2 10.3374 2.00269 14.6445 6.81104 -1.01801 -3.49857 -106 1 2.7507 12.9226 7.76103 -0.99391 -3.54814 -5.35437 -107 2 3.2837 13.6196 7.35675 1.026 0.47841 4.16479 -108 2 2.1823 12.6261 7.03948 -5.64928 1.37633 4.69044 -109 1 3.65655 11.6901 5.29539 -1.74666 1.04695 -5.47464 -110 2 3.42979 10.9863 5.91968 -0.390133 2.11749 -7.53732 -111 2 2.90341 11.8434 4.69867 6.59799 -3.91283 3.78854 -112 1 6.86195 14.4839 16.8677 -6.59977 -5.37582 9.26387 -113 2 7.63594 13.9204 16.7929 -0.0312736 1.63672 -3.94334 -114 2 6.43125 14.5303 16.0039 6.73415 3.59122 -3.18668 -115 1 14.1795 14.5536 3.39757 15.4782 -5.44823 -10.5 -116 2 13.7027 15.3725 3.25557 -8.02005 3.41109 -0.200737 -117 2 13.6761 13.9828 3.97966 -5.46722 0.130817 9.75683 -118 1 8.30625 18.1704 16.0558 -18.3501 -5.93921 0.16691 -119 2 8.73243 17.3486 16.3757 13.662 16.7968 -4.53324 -120 2 8.86048 0.311637 15.8745 11.2379 -14.2941 4.19403 -121 1 4.7262 1.6175 4.92485 1.6266 19.4211 -17.3379 -122 2 3.85517 2.05812 4.84475 13.0303 -7.24689 7.72044 -123 2 5.31448 2.15314 4.34837 -14.7695 -11.1634 6.67198 -124 1 15.0789 12.7964 16.4332 -6.30353 8.33681 17.3183 -125 2 14.5699 13.1854 17.1557 10.6035 -4.81202 8.18161 -126 2 14.431 12.7912 15.7403 -5.45963 -10.7064 -24.7799 -127 1 15.7876 18.4014 16.8102 7.97993 -1.6905 34.0366 -128 2 16.3475 18.509 17.631 -13.1355 2.97046 -27.3317 -129 2 15.4303 17.5059 16.9211 5.07282 4.66478 -9.26997 -130 1 1.15379 1.15776 16.5585 8.66192 -1.89028 -5.04545 -131 2 1.90132 1.75074 16.7615 -7.4852 -3.92147 5.78546 -132 2 0.484053 1.2881 17.242 6.61018 5.41271 -0.381602 -133 1 18.0958 4.56873 15.8951 8.25715 -8.22974 -2.59939 -134 2 18.5403 4.03662 15.2192 -4.31028 2.25805 3.56674 -135 2 18.6753 4.5681 16.6654 -3.11748 0.528024 -3.18079 -136 1 12.2229 16.9717 16.1366 4.99185 -14.9968 15.1993 -137 2 11.5697 16.3784 16.5746 6.13992 18.0067 -10.7689 -138 2 12.0903 16.9196 15.1862 -11.661 1.79059 -6.40221 -139 1 15.9175 2.52925 17.9868 -5.04918 24.4496 -1.91719 -140 2 15.7053 3.35036 18.4645 1.43445 -9.55155 0.206063 -141 2 15.6037 2.74854 17.0829 8.19816 -13.208 8.21894 -142 1 6.7035 13.812 10.2396 3.19471 14.7437 0.534165 -143 2 6.61208 13.6203 11.1841 -1.85117 -10.3739 -2.65392 -144 2 6.65674 12.9942 9.7292 -2.15383 -4.24588 3.01674 -145 1 10.13 18.2471 2.79005 6.2323 7.4499 -7.90816 -146 2 10.2641 0.289717 2.1086 -4.88175 -4.44055 6.63338 -147 2 9.27512 17.8471 2.59242 -0.00557908 4.28296 0.85488 -148 1 2.97726 17.7544 6.09154 9.3411 -8.798 -12.7807 -149 2 2.21419 17.6669 5.51339 -17.57 2.09099 8.77855 -150 2 3.67394 17.6484 5.43984 9.00485 8.25893 -0.00709571 -151 1 12.565 16.9537 7.99058 7.14198 1.79921 -4.31208 -152 2 11.8238 16.3251 7.88339 1.67036 10.005 4.65414 -153 2 12.3624 17.6704 8.62526 -6.57036 -14.6618 3.16709 -154 1 14.8823 15.2807 8.26789 -1.91265 -14.526 28.7428 -155 2 14.153 15.9118 8.23916 -2.47753 6.09246 -10.9919 -156 2 15.4304 15.3156 7.48892 0.613021 10.1448 -23.5664 -157 1 17.5919 18.2849 0.376053 -34.2379 -2.64943 -3.08159 -158 2 18.3697 17.8673 0.0312256 25.6277 -7.0964 -1.13253 -159 2 17.798 0.454484 0.829223 12.3697 7.05842 3.85092 -160 1 0.890355 10.3869 1.40531 11.5261 -26.8893 18.421 -161 2 0.106732 9.81739 1.52594 3.68606 12.403 0.666184 -162 2 0.670163 11.0869 0.811123 -14.943 21.2909 -16.3167 -163 1 1.59243 12.2061 3.32787 10.8868 -1.98125 32.4665 -164 2 1.41581 11.4302 2.79423 -4.35317 -0.696655 -17.6875 -165 2 1.68603 12.9921 2.7891 -2.29445 2.46974 -13.9165 -166 1 0.556424 17.2525 4.88159 28.516 -3.31441 -27.2608 -167 2 -0.112492 17.9263 4.93691 -11.7284 7.93843 13.1539 -168 2 0.513874 16.5834 5.55808 -11.2757 -6.6263 16.6148 -169 1 1.11617 0.979823 9.41029 -8.01472 5.90786 -6.49609 -170 2 1.17088 0.754182 10.3385 12.3333 -8.44182 10.8127 -171 2 0.193916 0.78552 9.22994 -1.98368 -3.92324 -6.63209 -172 1 16.7786 2.33534 13.2836 0.301257 -1.02782 -8.61363 -173 2 16.9098 2.55877 12.34 -0.551981 -1.96326 12.3514 -174 2 16.5533 1.39033 13.3371 -1.81134 4.54396 -2.66642 -175 1 2.50838 15.8231 12.1881 11.0759 -0.61625 -4.91684 -176 2 3.05623 15.4799 12.9137 -5.11001 1.87196 -7.11666 -177 2 2.97562 15.6336 11.349 -1.75425 -0.738878 7.05871 -178 1 16.4241 15.5762 5.95419 20.8818 34.7414 3.73321 -179 2 17.3417 15.6388 6.29893 -10.1511 -9.39035 -1.02331 -180 2 16.3256 16.4387 5.46724 -6.92566 -23.7939 4.29358 -181 1 5.82318 5.04015 11.787 7.38202 -1.28642 -1.97288 -182 2 5.53279 5.76584 12.3478 -8.19426 6.74642 1.34004 -183 2 5.25308 4.28957 11.9879 -3.19521 -0.0404241 -0.10221 -184 1 15.2058 4.86095 0.714988 -15.0911 -0.578133 32.6943 -185 2 15.0554 4.65905 1.68214 1.80466 1.09263 -27.7183 -186 2 14.3514 5.22673 19.0716 10.184 -3.76227 -2.57358 -187 1 16.3414 16.3313 2.1188 1.69452 -20.4231 -15.1031 -188 2 15.9696 16.7397 2.89766 0.772445 11.9995 9.83785 -189 2 16.487 17.0139 1.46036 1.64169 8.90638 2.00624 -190 1 0.27953 4.87193 3.80304 22.0083 21.7264 1.42732 -191 2 0.488965 5.84197 3.75834 -13.581 -23.7134 5.51739 -192 2 1.12962 4.47493 4.05501 -10.8528 -1.93786 -0.672788 -193 1 2.93644 15.0118 15.0505 -0.31189 -6.67479 38.4938 -194 2 2.77152 14.5973 15.941 9.17422 6.49202 -18.5047 -195 2 2.6087 15.9081 15.2082 -8.55577 3.59906 -10.383 -196 1 1.11893 14.5977 9.54871 15.5404 -15.1461 3.70851 -197 2 2.05973 14.499 9.39244 4.56619 15.8955 -5.72674 -198 2 0.980037 13.7309 9.94382 -18.1835 3.0763 3.0761 -199 1 13.6623 16.6444 11.5318 -24.61 2.13122 1.95847 -200 2 13.1623 17.4223 11.2076 12.7863 -8.68657 -5.97173 -201 2 13.1098 15.8918 11.2458 9.29846 2.29742 -4.43006 -202 1 4.71401 1.48013 0.724257 -0.188744 -1.90188 8.47653 -203 2 4.10877 2.04213 0.209428 1.54459 -7.39683 1.44825 -204 2 4.1847 0.878426 1.28084 -4.13807 4.124 -10.8706 -205 1 1.4317 18.499 11.8861 -0.747589 2.74228 -9.05649 -206 2 1.26248 0.376362 12.6752 -1.22453 3.10674 7.57799 -207 2 1.76508 17.6414 12.1696 1.67944 -1.01146 1.59049 -208 1 11.5426 10.114 4.08871 14.5973 5.39555 -25.8673 -209 2 11.3947 10.5181 3.18641 4.0612 -8.18021 22.6028 -210 2 12.5241 10.0302 4.19261 -20.6338 4.9276 -1.52234 -211 1 8.35442 12.1679 3.75067 -15.8416 -4.27069 -7.38356 -212 2 9.18656 12.6319 3.95442 -10.6107 -0.215004 12.2135 -213 2 7.67679 12.3128 4.45645 22.0699 3.83678 -6.48541 -214 1 14.3334 4.02625 3.28975 21.4077 6.9275 8.44763 -215 2 15.0849 4.22802 3.89908 -16.2072 -5.96795 -3.3621 -216 2 13.5509 4.49592 3.62574 4.82101 -0.669553 -3.42678 -217 1 5.57933 1.73516 7.50739 -24.0378 -31.7376 11.0088 -218 2 4.91074 1.07012 7.91595 32.7583 31.1537 -18.2093 -219 2 5.45045 1.65908 6.53973 -4.97377 0.997246 11.1506 -220 1 17.8945 1.1186 4.8831 -1.36037 -2.43827 -6.93143 -221 2 18.5804 1.42855 4.26031 -6.60553 2.78724 7.64102 -222 2 17.8025 1.76232 5.59874 4.87877 0.216211 -3.29328 -223 1 6.83024 9.40422 4.48506 -14.9488 0.581331 -12.2421 -224 2 6.75886 9.5424 5.43046 9.61942 2.86103 10.3107 -225 2 7.75214 9.21615 4.27366 4.86133 -4.03573 4.34319 -226 1 2.68867 14.9529 1.96243 -3.68441 -0.0776758 1.15821 -227 2 3.24659 14.6776 2.70632 3.58292 1.9147 -7.42106 -228 2 3.21497 14.9558 1.15083 1.81588 -2.88288 8.16929 -229 1 17.2949 12.8929 13.1574 -7.5849 14.4302 -4.04848 -230 2 16.4401 13.3055 13.2858 -13.783 -13.5119 9.83474 -231 2 17.7157 13.6748 12.8001 24.9453 0.592093 -1.55303 -232 1 15.0095 10.5719 1.38917 -11.2702 -15.2105 -5.46509 -233 2 15.5687 11.2426 1.76309 11.9887 12.322 8.95719 -234 2 14.2298 11.0424 1.10476 -6.47688 3.25886 -0.810136 -235 1 5.70264 6.91192 4.53101 4.96234 -7.94583 8.40724 -236 2 5.98573 7.83684 4.52277 1.36545 -0.678753 -1.4492 -237 2 6.33051 6.43499 5.10591 -2.47306 1.6182 -5.79546 -238 1 8.0801 8.26782 10.1943 -2.48094 -3.5573 30.8197 -239 2 8.76371 8.85191 9.85613 0.308879 9.43682 -13.0265 -240 2 7.56027 7.88877 9.48994 -2.62488 -0.283604 -15.3664 -241 1 13.5 18.3149 5.7974 -5.02979 10.2931 3.81039 -242 2 12.85 0.37996 5.63415 -2.0272 -10.2183 1.79381 -243 2 13.182 17.8392 6.59435 1.6098 2.02728 -12.9685 -244 1 0.276709 2.57627 0.11216 -0.0492842 3.76989 10.2262 -245 2 17.9528 2.7291 18.6895 13.0336 8.33648 -1.41355 -246 2 0.811706 3.36861 0.368499 -21.4808 -7.42382 -6.02819 -247 1 12.6714 10.9997 9.76016 -23.5437 -7.71308 -4.31472 -248 2 11.7133 10.8659 9.59681 15.3229 11.3368 0.532821 -249 2 12.914 10.0869 9.9422 13.3726 -3.72203 6.47581 -250 1 0.779958 12.2601 11.0819 -4.3547 -6.1438 5.62044 -251 2 18.4678 12.2984 11.1653 -6.51403 -1.20026 -7.70008 -252 2 1.07438 12.4529 11.9792 8.34734 4.57522 -3.24255 -253 1 5.0586 7.24501 13.467 -14.0099 -7.28532 -8.10759 -254 2 5.49528 8.03405 13.1289 12.6282 1.90126 -2.15469 -255 2 5.51501 6.98287 14.2704 7.34444 5.85192 6.7727 -256 1 1.26105 6.94281 11.8301 -2.26861 -4.26975 2.97 -257 2 0.502637 7.2894 11.3564 -2.98104 -0.152382 -1.57853 -258 2 1.67901 7.71469 12.2201 5.00338 4.10874 -3.32488 -259 1 15.4732 9.48624 12.3091 -7.90575 31.4836 20.4854 -260 2 15.2888 10.4503 12.3878 3.68649 -17.5592 -11.9783 -261 2 15.3484 9.17907 13.2194 3.56004 -6.14635 -9.9625 -262 1 16.6235 12.9071 5.45115 4.22183 -17.5767 13.0612 -263 2 16.4576 13.8585 5.58703 -5.89626 -6.38642 -16.4082 -264 2 16.4453 12.6107 4.54016 -1.61972 14.741 3.30454 -265 1 6.17978 10.0207 0.140312 6.69901 -0.902574 1.02107 -266 2 5.53175 10.4562 0.704359 -7.04498 -0.0752206 -3.29626 -267 2 6.99223 10.1412 0.643131 5.59964 -6.49227 2.85612 -268 1 12.3558 6.06094 4.04059 -1.82306 -10.4932 18.2897 -269 2 12.2948 6.89378 3.5711 -3.30175 6.87328 -14.7087 -270 2 11.4523 5.72881 4.15047 2.03572 4.51633 -5.92335 -271 1 0.151611 12.8143 0.201399 6.45324 -5.46068 -3.81056 -272 2 -0.0140355 13.4798 0.883392 3.4035 3.37155 -1.9342 -273 2 18.3672 13.1447 18.0414 -1.87626 -1.08321 2.97259 -274 1 3.81145 18.5877 8.5912 1.31461 -3.73146 5.16785 -275 2 3.56882 18.0432 7.82418 -6.49798 6.54364 1.53441 -276 2 2.99788 0.372962 8.89657 -5.11276 -3.31294 -4.1744 -277 1 7.4281 17.2705 4.47377 6.46179 23.4452 -11.2721 -278 2 7.96797 18.0618 4.61565 -3.66399 -5.46425 9.5792 -279 2 7.28703 17.3462 3.52078 -0.310988 -11.8901 2.26571 -280 1 9.22893 17.063 12.2466 22.6161 -18.3078 -0.374418 -281 2 9.25634 16.2959 11.6379 -2.98004 10.6911 5.23864 -282 2 10.0783 16.9759 12.7442 -18.2994 12.1316 -6.13803 -283 1 13.3197 12.9538 7.95187 -9.96581 2.72298 -9.05352 -284 2 13.2593 12.2563 8.62517 4.24613 3.77329 1.00191 -285 2 13.899 13.6706 8.22561 11.1032 -0.425478 9.75376 -286 1 14.9719 2.96045 15.3396 1.81329 0.120121 -0.870248 -287 2 14.3995 2.21229 15.1018 3.59949 7.50345 -3.65154 -288 2 15.6901 3.005 14.6772 -10.8991 -3.85704 4.22675 -289 1 9.85324 15.5257 17.0014 3.97317 -4.57748 -3.47476 -290 2 10.3864 14.7538 16.7592 -3.54516 -0.814303 -2.23392 -291 2 9.2485 15.2429 17.6987 -0.194096 3.36496 6.55889 -292 1 11.2976 8.26736 16.5426 7.06128 19.5884 6.19806 -293 2 10.6048 7.82655 16.0501 -2.15009 -7.46249 -5.1526 -294 2 11.6506 7.64084 17.1804 -3.23764 -5.26669 1.48715 -295 1 3.80261 18.1891 16.7286 5.96532 3.63646 9.58286 -296 2 4.2558 17.5705 17.3068 2.57751 -13.4277 -2.28373 -297 2 3.88923 0.356458 17.2317 -6.08372 7.81341 -6.39572 -298 1 2.19516 4.11859 8.94937 -6.46461 1.56382 -5.27436 -299 2 3.07192 3.77694 8.7043 -7.24867 0.753394 12.5906 -300 2 2.01364 3.98399 9.90559 16.1239 2.6739 -11.0998 -301 1 9.88488 10.3605 9.72172 5.12637 14.4569 -2.91242 -302 2 9.60959 11.2332 9.33432 -0.0101703 -19.6763 14.6837 -303 2 10.1282 10.4603 10.6632 -8.0115 2.48909 -7.97128 -304 1 9.71465 0.804575 10.8512 21.7431 15.3431 10.1505 -305 2 9.2832 18.6897 11.2643 -8.53487 -4.69507 -4.97966 -306 2 9.18676 1.22081 10.1628 -13.1132 -5.80645 -3.94121 -307 1 9.20675 15.1716 10.2106 -23.935 -1.88548 4.57185 -308 2 8.85892 15.9372 9.71979 2.38257 -5.68301 1.50138 -309 2 8.39577 14.638 10.4071 17.7258 6.53325 -11.5344 -310 1 1.0072 9.34307 10.3251 -13.5607 -2.30165 -2.87521 -311 2 1.0259 10.3094 10.4263 12.3488 -1.76633 0.307332 -312 2 1.88127 8.96784 10.1532 -1.03643 13.7416 3.72628 -313 1 16.8438 4.87108 8.18901 -4.78961 0.896955 11.5039 -314 2 16.1406 5.46499 8.54396 15.0863 -10.4307 -3.41532 -315 2 17.2081 4.33923 8.92353 -6.78534 8.8584 -10.8667 -316 1 14.6587 14.7041 0.366828 1.30507 -0.478814 3.63059 -317 2 15.185 15.0332 1.12636 -7.04307 -0.464202 -11.0373 -318 2 13.8385 14.3426 0.742198 8.82268 0.591631 -2.33039 -319 1 3.54036 11.0513 9.61487 2.50715 2.61524 -7.45538 -320 2 3.63629 11.5626 10.435 -2.71976 -6.10697 -0.243655 -321 2 3.06413 11.634 8.99273 6.16009 -0.263385 5.30284 -322 1 11.0628 10.8412 1.29387 1.94664 2.31063 1.36488 -323 2 11.3352 11.6508 0.816723 -4.4237 -7.82009 8.11802 -324 2 10.1138 10.7005 1.1254 8.25661 2.0034 -0.662671 -325 1 13.2071 7.092 12.8743 -8.181 6.96481 -7.78695 -326 2 14.1492 6.89693 12.9368 4.59729 -0.0390769 -2.26511 -327 2 12.7747 6.23567 12.7699 0.0352738 -4.27477 4.68983 -328 1 9.62872 1.89049 0.957357 1.17656 -1.16236 13.2501 -329 2 8.73134 1.77169 0.632677 -1.73422 -2.0126 -6.33446 -330 2 10.2301 1.88378 0.211292 -0.739962 2.15457 -7.7161 -331 1 10.5914 13.525 4.7165 6.94092 6.03141 -14.7136 -332 2 11.5001 13.1966 4.5902 -6.55933 -2.4681 12.9436 -333 2 10.616 14.067 5.5206 3.43098 -5.16043 -1.25188 -334 1 14.3018 1.72484 10.9172 13.4371 11.1223 -9.93713 -335 2 15.1272 1.43467 10.5035 -1.81024 -10.6133 4.43081 -336 2 14.4134 2.68551 10.8564 -6.433 0.422524 6.62217 -337 1 14.6521 12.3877 11.7022 -8.45049 -6.71538 5.80805 -338 2 15.5103 12.5052 11.2413 -17.7577 -5.57988 -7.54306 -339 2 13.9188 12.0751 11.1197 22.5147 4.82958 0.534535 -340 1 8.2427 5.06906 9.80652 6.55588 21.6544 3.19941 -341 2 7.41824 5.23391 10.2944 2.41744 -11.9303 -3.89737 -342 2 8.21758 4.20856 9.37923 -10.585 -10.7296 4.55255 -343 1 1.58459 16.8369 18.3321 1.96955 3.78018 0.59611 -344 2 1.85004 17.2184 17.4898 0.0469727 3.49377 1.52109 -345 2 1.98826 15.9645 18.3052 -5.87072 -8.1408 0.0386171 -346 1 1.45085 17.2397 15.3384 19.3024 -11.6024 -7.75777 -347 2 1.52928 18.1033 15.7334 -7.82156 13.9033 4.46915 -348 2 0.523156 17.01 15.2404 -5.15812 1.64021 5.22009 -349 1 3.71432 5.60797 6.16821 -6.42766 23.1509 5.2389 -350 2 3.10788 6.20238 6.65309 4.74203 -10.8724 -0.844938 -351 2 4.31902 6.23597 5.73943 -0.58891 -7.80382 -7.69424 -352 1 12.3617 9.44178 14.1897 14.768 -21.5294 -7.13739 -353 2 12.6854 8.60646 13.7318 -7.61852 23.4532 21.1317 -354 2 12.1886 9.19254 15.1239 0.0190459 -2.13671 -14.4759 -355 1 4.02789 15.2847 6.90037 19.6963 3.91174 -8.53909 -356 2 3.59813 16.0446 6.4807 -5.57314 -2.58109 7.58101 -357 2 4.98627 15.4174 6.72455 -14.0806 -2.64155 5.91133 -358 1 0.604694 8.56382 14.8836 6.38519 14.8729 2.46932 -359 2 0.593576 9.52815 15.0331 -4.38489 -7.16014 1.99766 -360 2 1.21683 8.48632 14.1406 0.0450847 -3.26888 3.80333 -361 1 12.9907 8.33553 10.3435 -10.7244 11.0212 -25.595 -362 2 13.7217 7.85043 9.92864 1.48882 -4.14748 10.5805 -363 2 12.916 8.06476 11.2563 9.06532 -10.0671 12.5191 -364 1 15.3021 7.67479 3.50456 -15.706 -31.6797 19.6454 -365 2 14.5991 7.08356 3.22123 -2.84665 13.9574 -20.9494 -366 2 15.4859 7.21773 4.34079 18.8178 22.1978 3.49889 -367 1 17.3057 6.66581 0.0439089 -0.566439 -0.157214 -4.14934 -368 2 16.9415 5.80914 0.322205 -4.36129 9.908 -1.962 -369 2 16.5386 7.21525 18.4101 8.51434 -8.37768 3.91558 -370 1 8.82219 6.93132 7.84612 -10.1525 -9.67927 6.48857 -371 2 9.74438 7.17539 7.82243 13.4851 9.91198 -3.74634 -372 2 8.75511 6.31699 8.60098 -3.86074 2.18846 -4.69843 -373 1 12.3417 0.621389 1.18077 -6.9564 -3.41972 6.83906 -374 2 13.1525 0.726993 1.70017 3.48999 0.0677543 -9.59522 -375 2 12.4857 18.5505 0.551479 3.63823 3.88808 0.842467 -376 1 5.6677 15.1168 14.5202 -2.89809 14.409 3.62726 -377 2 4.73779 15.2069 14.7798 -2.10515 -4.92641 -4.42493 -378 2 5.95698 16.02 14.2745 1.37709 -12.0745 -2.57764 -379 1 3.85174 6.50812 1.71549 -1.87326 -9.92841 -7.94113 -380 2 3.40118 7.27684 1.32447 4.40945 3.56133 7.79633 -381 2 3.98293 6.6854 2.65555 -2.72837 5.07562 -0.486349 -382 1 3.88774 11.6179 12.2731 7.36248 2.53406 3.74193 -383 2 4.74563 11.9961 12.5096 3.21135 -1.44769 -3.24982 -384 2 3.26188 12.2215 12.6852 -7.1456 -2.35069 3.20446 -385 1 5.4326 3.86602 15.8669 5.46195 27.5847 5.5501 -386 2 6.12196 3.19729 15.7751 -0.292732 -1.96119 -5.07149 -387 2 5.89955 4.7414 15.9262 -11.6823 -23.746 -2.53289 -388 1 14.4519 10.31 4.40466 -0.198609 -22.4452 -14.1251 -389 2 14.647 9.76314 5.18938 0.972168 3.21729 -6.37484 -390 2 14.6939 9.77999 3.59617 -3.45576 13.8176 24.0335 -391 1 7.91012 17.3396 9.21881 -3.47249 -5.09989 3.31179 -392 2 7.12992 17.5549 9.76562 5.48476 5.05439 -11.164 -393 2 8.00718 17.9294 8.44912 -7.46491 1.16212 7.11091 -394 1 4.51961 14.4455 3.97665 1.46094 13.6517 19.4367 -395 2 4.57851 15.3966 4.28178 1.46521 -27.5553 -6.05216 -396 2 4.65578 13.8277 4.74009 -3.41874 17.0045 -15.0106 -397 1 14.2914 7.39173 15.7568 2.67151 4.01398 13.8033 -398 2 15.2382 7.26829 15.5879 -5.04223 1.8615 0.0507223 -399 2 14.2621 7.71182 16.6758 1.37252 -0.910778 -10.0112 -400 1 2.89282 18.2219 1.89623 16.0954 20.7868 19.4211 -401 2 2.43498 17.5738 1.38145 -10.8581 -14.0242 -17.961 -402 2 2.20473 18.7378 2.33948 1.00824 -0.59586 0.163903 -403 1 7.97772 1.60288 4.53639 1.7563 -9.68985 13.008 -404 2 7.31922 2.029 3.97737 7.04095 6.46018 -8.6135 -405 2 8.84264 2.02013 4.43356 -4.53303 1.60821 -5.92451 -406 1 2.59943 14.1332 17.7414 -8.95394 -18.2677 -2.38171 -407 2 1.94944 13.4122 17.9464 12.5244 20.6844 1.19004 -408 2 3.47205 13.7759 17.9983 -8.8914 0.728457 0.900702 -409 1 0.745112 1.69912 13.8711 11.2473 3.52367 -11.146 -410 2 0.914419 1.4049 14.7673 -7.77297 1.70239 6.88788 -411 2 18.4589 1.93825 13.7842 -0.334419 -0.897106 4.15254 -412 1 4.53599 18.6175 13.9535 -3.4557 6.59794 -4.70782 -413 2 5.46815 18.3485 13.9788 -8.18255 -2.00556 -1.03369 -414 2 4.11637 18.3402 14.7801 5.6735 0.958275 2.99437 -415 1 7.096 0.531319 18.3551 -0.694611 7.4496 8.80978 -416 2 7.23097 0.178113 17.4735 2.95576 -3.96306 -6.42653 -417 2 6.14085 0.633472 18.4745 3.33236 6.58102 0.363951 -418 1 16.0915 18.4336 14.0959 0.427379 -0.396215 -8.58483 -419 2 15.3508 17.8946 13.7703 3.59427 8.97013 10.1541 -420 2 15.9721 18.7209 15.0186 -4.35198 -12.8399 -3.85995 -421 1 10.0849 4.5187 16.2702 4.73223 -5.50586 5.92697 -422 2 10.9866 4.63155 16.5807 5.77761 8.19399 -3.69287 -423 2 10.0461 3.5611 16.1717 -6.80252 -1.66686 -4.51665 -424 1 15.8725 17.8845 4.41654 -12.5209 12.7326 5.37596 -425 2 16.3916 18.7124 4.49019 -1.68969 -11.5252 -1.94643 -426 2 14.9593 18.1341 4.67479 17.449 -5.50076 1.40971 -427 1 6.95668 17.3709 13.7302 27.0332 5.97859 23.7699 -428 2 7.35597 17.5596 14.624 -6.60353 0.436933 -26.7426 -429 2 7.73328 17.3113 13.1176 -17.9234 -0.691624 11.5164 -430 1 13.2886 6.54141 6.708 -19.4099 -8.32294 21.4331 -431 2 14.1944 6.83212 6.62317 10.4169 5.52785 -11.9279 -432 2 12.8902 6.38702 5.85009 7.8467 0.777822 -14.5162 -433 1 7.70655 2.38278 9.20977 12.6343 0.60353 -10.8933 -434 2 7.2325 2.23152 10.0347 -6.87682 0.627979 2.4454 -435 2 7.14224 2.1131 8.46352 -1.96859 -1.38987 10.9664 -436 1 15.1599 14.8609 13.6555 2.14917 -2.72077 3.1958 -437 2 15.0894 15.1454 14.5818 -4.10533 -0.470809 -6.08849 -438 2 14.3857 15.1548 13.1581 4.50097 1.9243 4.2209 -439 1 9.31836 8.32368 3.71602 18.5592 -2.51714 11.5674 -440 2 10.1335 8.79007 3.99631 -8.14035 -3.14117 -4.90658 -441 2 9.4898 7.3827 3.90713 -7.2783 5.8685 -3.93333 -442 1 17.7186 13.4905 16.4359 -1.51289 22.2408 -13.156 -443 2 16.7625 13.3639 16.3649 1.62841 -7.26982 3.16217 -444 2 17.8329 14.3608 15.9953 4.68582 -10.1291 6.26608 -445 1 5.02763 10.6563 2.64305 -2.13744 -9.22816 3.31541 -446 2 5.67739 10.1782 3.18798 -3.0773 8.85482 -0.1212 -447 2 4.59818 11.3042 3.21285 3.70326 -1.5106 2.19329 -448 1 3.72149 8.34459 10.2919 -0.179455 -7.68631 -12.7595 -449 2 3.82782 9.26393 10.0171 0.460185 9.10653 3.72446 -450 2 3.7984 8.31763 11.2506 0.24707 1.5831 -0.943414 -451 1 16.0782 7.09232 6.27704 3.78536 -20.3998 -1.61032 -452 2 16.8668 7.5306 6.63092 -6.12864 4.03671 -1.53431 -453 2 16.2929 6.14181 6.32149 -2.48234 12.3559 -4.92911 -454 1 15.1572 7.02511 9.10581 3.8117 16.1939 -22.7388 -455 2 15.9823 7.33517 9.52567 -10.9007 1.4123 -2.48218 -456 2 15.0452 7.59247 8.29613 6.45133 -12.7204 22.5185 -457 1 6.42341 13.1088 12.8743 -8.95622 -6.97199 -8.56847 -458 2 7.13157 12.5608 13.2501 0.579484 9.04377 -2.95583 -459 2 6.27581 13.8943 13.4207 1.62934 -6.42573 5.92996 -460 1 12.1251 4.48872 13.0852 20.6978 11.8008 -11.4801 -461 2 12.1861 4.63134 14.0408 -7.38726 -2.06828 2.45652 -462 2 11.3124 4.06154 12.8314 -12.072 -7.43803 9.29181 -463 1 11.3394 8.19587 7.85205 11.1059 -10.4301 17.8484 -464 2 12.0348 7.61277 7.52234 0.357557 0.521252 -13.0071 -465 2 11.6101 8.269 8.78041 -6.91702 7.4869 -1.95681 -466 1 17.1867 10.7889 7.4395 14.5297 -2.81026 -23.5185 -467 2 17.9096 10.1869 7.16109 -12.9834 1.71839 15.1597 -468 2 17.0415 11.3048 6.62611 -4.1729 8.16775 12.482 -469 1 5.24074 18.1281 11.0581 -15.2173 -3.98599 -8.34189 -470 2 4.58924 18.0057 11.7782 10.2636 1.95052 -8.13419 -471 2 4.73144 18.0737 10.2167 7.33147 4.07832 13.9505 -472 1 7.57528 17.5815 1.8237 -4.07192 12.6902 15.9513 -473 2 7.93668 16.805 1.40258 -2.93669 -7.99436 -16.24 -474 2 7.56667 18.3008 1.17772 -1.22407 -7.09592 -6.98677 -475 1 1.89335 12.9293 13.6081 -2.83392 -4.38044 7.70492 -476 2 1.42634 12.2947 14.1785 7.13969 5.03303 -2.73416 -477 2 2.14611 13.6729 14.1857 -2.01709 -2.63559 -9.61881 -478 1 9.71667 6.79197 14.8165 -19.737 27.0922 8.68981 -479 2 9.89359 5.91802 15.1417 7.60675 -24.7177 2.15595 -480 2 10.032 6.8882 13.9194 5.10262 -3.22926 -9.37061 -481 1 15.2334 4.35765 10.7756 -27.5978 -16.2477 -22.3588 -482 2 16.1684 4.22394 10.6591 16.9939 1.30069 13.5789 -483 2 15.041 5.04225 11.4098 10.4595 11.1452 11.1309 -484 1 11.214 6.13659 0.181715 -19.0514 -14.6776 -12.5318 -485 2 11.2124 5.17659 0.0304417 14.0569 6.29109 5.62342 -486 2 10.2823 6.34718 18.6411 6.7491 10.3457 6.1137 -487 1 0.148583 11.3373 15.1258 -19.5821 15.0001 -24.2151 -488 2 18.1981 11.6758 14.382 16.6378 -5.64999 24.2973 -489 2 18.7581 12.0391 15.8029 -7.9684 -6.15355 -5.02438 -490 1 7.07881 9.17505 7.27008 -6.43803 -1.74166 -4.58486 -491 2 6.45798 8.45812 7.48524 7.10939 3.15379 4.24177 -492 2 7.95401 8.76045 7.26417 -3.66954 2.28396 2.09633 -493 1 18.4168 15.4276 12.3546 -3.43386 -0.549873 -4.48624 -494 2 0.729474 15.5504 12.2627 0.527014 -4.05801 2.94094 -495 2 18.0745 15.7474 11.5108 -2.98934 0.409485 0.218187 -496 1 16.554 4.36499 5.23729 20.8954 -6.05263 25.9175 -497 2 16.7683 4.14077 6.16822 -16.8827 1.59137 -12.628 -498 2 17.4495 4.42836 4.87212 -5.6372 6.04853 -15.3532 -499 1 17.7678 3.07292 10.7257 -2.33819 12.1961 -2.64827 -500 2 0.05876 3.27172 10.9273 -5.50289 -7.01135 -0.383438 -501 2 17.6798 2.21428 10.2822 5.02163 -0.151153 2.81987 -502 1 12.2925 0.0394171 10.1485 -5.03026 26.5344 11.6637 -503 2 11.4572 0.407352 10.526 9.87088 -12.259 -12.5756 -504 2 12.9102 0.803778 10.1803 -6.63246 -15.2789 0.0865208 -505 1 10.3587 9.80679 12.3603 15.6128 10.3756 0.750657 -506 2 11.1656 9.89562 12.9016 -9.14674 -1.49827 1.04164 -507 2 10.2822 8.8615 12.2126 -4.78815 -8.04326 1.85351 -508 1 0.512396 2.83902 7.01376 3.84696 0.0782361 15.1378 -509 2 0.640445 3.53836 7.66576 0.959953 5.26089 -8.6545 -510 2 0.680944 2.06786 7.56376 2.06531 -6.50055 -6.8896 -511 1 0.435055 15.2675 6.92024 15.2549 -35.398 4.87844 -512 2 0.621058 15.2814 7.87767 -6.30652 4.63478 -5.55491 -513 2 0.767833 14.3496 6.68755 -16.1257 30.2961 -2.9732 -514 1 16.9932 7.01767 15.3053 -26.5651 1.45521 -6.17716 -515 2 17.7481 7.60304 15.1777 11.1425 -6.61607 -1.97906 -516 2 17.2478 6.0923 15.4082 16.5215 2.79636 5.68328 -517 1 9.018 12.4253 8.12635 6.95093 19.302 15.9025 -518 2 9.42759 11.8305 7.48541 -10.9396 -6.20971 -13.8418 -519 2 8.05723 12.5431 8.02215 9.94353 -10.4145 -8.12359 -520 1 1.2603 1.92339 3.03777 4.00037 -11.2111 -0.333139 -521 2 0.985763 2.4239 2.25859 3.27899 1.87382 4.37683 -522 2 1.94434 2.40743 3.53125 -8.95634 4.24445 -6.71947 -523 1 4.13152 15.1081 9.6737 -15.9579 5.42681 13.2475 -524 2 4.06185 15.276 8.72578 6.37214 -2.02945 -0.454299 -525 2 5.01049 14.775 9.87491 6.77649 -3.08542 -5.82222 -526 1 7.18656 2.18024 14.5742 6.63684 0.423238 1.66106 -527 2 6.97291 1.78224 13.7284 -0.102066 -5.66692 0.745345 -528 2 7.71431 2.94579 14.3335 0.160548 4.26015 2.86325 -529 1 18.6004 14.6938 2.16823 2.76542 -5.02319 -0.780568 -530 2 0.802927 15.1539 2.18876 5.80577 -4.93168 -0.456722 -531 2 17.9585 15.3989 2.13554 -15.1748 6.08707 3.47143 -532 1 9.94779 2.77101 12.9402 13.7079 -4.8088 0.992354 -533 2 9.86912 2.18708 12.1681 -6.43941 0.85112 1.08944 -534 2 9.26112 3.44421 12.9098 -9.63803 -0.00730006 -3.05418 -535 1 2.82654 8.93218 13.0337 -16.8853 -9.00607 0.122573 -536 2 3.25687 9.752 12.7946 6.59476 15.835 -2.70012 -537 2 3.50997 8.32082 13.3007 12.5319 -6.06263 8.37491 -538 1 3.22862 8.37837 3.65188 -0.226515 1.69475 29.0088 -539 2 3.688 9.03214 3.10752 1.26352 6.15003 5.24259 -540 2 3.37942 8.56962 4.62044 0.873457 0.138782 -29.442 -541 1 5.6209 7.19208 8.52428 9.74274 9.28918 -7.76376 -542 2 5.82768 6.24803 8.58864 -11.1579 -1.95789 2.42461 -543 2 4.98617 7.45468 9.2041 -0.288223 -8.23268 4.91577 -544 1 14.8711 1.29057 2.00464 8.31119 17.2873 -6.28041 -545 2 14.835 2.11415 2.48745 -9.33397 1.40045 17.6104 -546 2 15.2356 1.62076 1.17953 -0.998754 -14.9614 -12.238 -547 1 8.25883 15.2026 0.830681 5.29747 -5.49957 9.6471 -548 2 8.95156 15.1522 1.50066 13.8019 -1.55539 -6.59484 -549 2 7.5748 14.6468 1.22478 -8.81297 0.605757 -6.77665 -550 1 15.6232 1.34362 7.23598 -18.647 -1.91314 -11.6656 -551 2 14.9897 0.764646 6.76092 12.0508 5.58891 7.1025 -552 2 15.1447 2.18632 7.33027 3.5178 -4.19741 5.22167 -553 1 4.94904 13.0769 18.5237 9.6722 0.589191 0.374268 -554 2 5.36668 13.208 0.749415 -4.04426 -2.7658 -6.21312 -555 2 5.63686 13.3362 17.8955 -3.04446 1.7017 1.4528 -556 1 15.3696 8.47999 18.1528 -1.21138 17.1653 -12.6794 -557 2 15.695 9.10606 17.469 -1.13375 -12.9806 6.06144 -558 2 15.1122 9.07709 0.225504 3.72099 -3.98362 5.25331 -559 1 12.0892 3.03182 18.3639 -14.1234 30.4246 -7.06661 -560 2 12.0418 2.65673 0.600248 11.0312 -14.2758 -1.1161 -561 2 12.4684 2.43863 17.7097 5.58993 -13.4699 6.64437 -562 1 13.2076 12.6677 5.18878 -11.1257 12.6934 -18.8931 -563 2 13.6382 11.873 4.85103 6.50507 -2.50005 7.23376 -564 2 13.4408 12.7972 6.11334 1.90386 -8.97209 5.02297 -565 1 6.04179 7.07685 0.0416979 2.64097 -12.2137 0.441028 -566 2 5.97681 7.98433 18.9573 -0.86164 23.926 -2.06041 -567 2 5.22747 6.68409 0.369779 -2.28588 -4.24693 2.31783 -568 1 17.7316 15.9939 15.0114 -15.9363 1.83518 -2.01139 -569 2 16.8954 16.4456 15.035 -7.98632 8.38962 22.0218 -570 2 17.7728 15.8943 14.0703 21.4922 -14.9825 -23.1623 -571 1 13.1856 0.993654 16.5812 4.51688 -6.04585 -7.39508 -572 2 14.1484 0.841574 16.6066 -7.22778 -1.30407 6.3933 -573 2 12.7998 0.141541 16.3207 3.39554 1.08214 8.76474 -574 1 11.0918 14.5789 7.23122 -0.0827639 9.53574 4.16562 -575 2 10.4295 14.1218 7.74457 -13.7426 -4.81361 3.6986 -576 2 11.9118 14.1808 7.52276 7.59678 -9.08814 -4.3045 -577 1 17.5016 8.6119 2.09076 15.8147 11.2146 7.10458 -578 2 16.6678 8.4072 2.52184 -8.49554 -5.1851 -0.954934 -579 2 17.6089 8.02126 1.34907 -7.08963 -15.2245 -7.94382 -580 1 12.3468 7.97644 1.98939 8.16003 1.60059 13.0036 -581 2 12.1059 8.91014 1.92161 -4.12319 -5.14517 -8.91961 -582 2 11.9653 7.48445 1.25112 -3.43761 0.267259 -0.201848 -583 1 11.9018 14.6174 10.3415 -1.61415 6.01794 0.545715 -584 2 12.1103 13.7968 9.87035 -7.85836 7.68399 3.13223 -585 2 10.9576 14.8558 10.2015 13.8599 -12.9225 1.87067 -586 1 6.88302 7.0351 15.5985 0.0361083 -3.88964 -3.36213 -587 2 7.78537 7.14813 15.233 -9.24764 2.66089 10.2853 -588 2 6.74206 7.63616 16.3488 6.91006 -2.15529 -8.72434 -589 1 7.99721 4.71198 13.4628 5.66523 -8.00363 0.660216 -590 2 7.27921 4.81457 12.8289 -1.54019 0.966988 -4.0678 -591 2 8.48375 5.53924 13.4635 -1.88422 3.21799 -0.709238 -592 1 13.4036 12.1691 14.2716 3.14721 5.94494 7.46154 -593 2 13.2707 11.2057 14.207 -2.45791 4.15826 -3.3873 -594 2 13.8696 12.4652 13.4742 -1.1423 -6.74147 -2.23487 -595 1 14.8179 9.43426 7.29668 -6.36233 -11.9657 -8.30628 -596 2 15.5946 9.98871 7.43973 -1.00608 2.08043 5.84882 -597 2 14.0417 9.81939 7.70717 2.29675 7.38462 3.05591 -598 1 12.6631 17.0342 3.08686 -0.647851 26.0284 13.2632 -599 2 13.0189 17.4392 3.9047 -6.62985 -13.126 -8.67274 -600 2 12.0984 17.7464 2.72355 6.77056 -16.0012 0.625123 -601 1 1.16659 7.14982 17.4488 -22.2539 0.168591 -14.6305 -602 2 0.289944 6.86023 17.7803 4.99818 12.4666 0.0121858 -603 2 0.976074 7.62854 16.6106 6.60301 -8.93429 9.27073 -604 1 12.7913 5.13723 15.6659 26.8924 -5.83385 4.65231 -605 2 13.5397 4.50448 15.7352 -14.8898 5.20509 -1.35689 -606 2 13.2524 6.00122 15.6738 -9.3883 -7.24139 -3.09335 -607 1 2.50717 3.39641 5.02544 -4.94238 4.99772 43.075 -608 2 1.86502 3.10611 5.74586 16.3729 8.7954 -24.7542 -609 2 3.07143 4.08677 5.47722 -17.3542 -15.0389 -19.8763 -610 1 8.33721 11.2536 13.4671 -31.8218 12.3906 11.8554 -611 2 8.27902 11.0779 14.4347 20.4393 -8.01279 -19.4916 -612 2 9.11607 10.9377 12.9927 6.53682 -12.2231 14.6875 -613 1 12.8982 1.36842 13.3393 -2.38428 13.9081 -24.9925 -614 2 13.3657 1.32357 12.4816 4.13856 -5.14841 14.3736 -615 2 12.4149 2.20238 13.2267 1.28817 -6.58848 11.7421 -616 1 6.36101 13.6632 2.13728 5.84509 3.64922 20.165 -617 2 5.80267 14.0802 2.81815 -1.42815 -2.61112 -9.48922 -618 2 6.96781 13.1347 2.6793 2.58248 -4.73497 -8.11447 -619 1 15.9275 6.58906 12.776 -13.2255 -11.9143 -7.63467 -620 2 16.5079 7.05171 12.1721 3.66176 7.36442 -5.52267 -621 2 16.2877 6.70509 13.653 8.87525 3.50761 9.55012 -622 1 16.8403 0.7053 9.59425 -10.8287 -6.51914 0.180126 -623 2 16.6786 18.4058 9.8215 7.5744 10.512 -7.34073 -624 2 16.3431 0.86575 8.76743 6.96547 -2.88011 1.97602 -625 1 6.14042 11.7236 8.37935 -13.4401 -40.1875 -12.4491 -626 2 5.21965 11.5178 8.67227 17.9013 7.59491 -1.88002 -627 2 6.47134 10.8481 8.01351 -3.81201 28.7474 13.2691 -628 1 2.85976 8.65216 0.41009 29.1416 -12.2873 -0.261225 -629 2 2.35956 8.19684 18.3517 -12.3126 13.3733 12.5274 -630 2 2.40304 9.34487 0.902258 -18.8466 -1.4582 -10.1697 -631 1 10.1473 10.4614 6.51315 3.14709 -2.48115 -1.63688 -632 2 10.5898 9.76783 7.02035 -1.8228 -0.602608 0.477386 -633 2 10.6086 10.4674 5.65949 -3.20151 3.83187 3.87642 -634 1 6.7508 15.7003 6.55579 -3.66232 16.9823 8.74149 -635 2 7.17195 16.1106 7.3235 -0.889674 -7.99055 3.10182 -636 2 6.78205 16.4211 5.90999 7.33374 -8.97986 -9.58603 -637 1 6.44532 13.1371 5.60194 -4.00449 -9.15456 -0.382904 -638 2 6.60496 14.011 5.98141 3.67218 -1.64471 2.17047 -639 2 6.02503 12.5975 6.28414 2.5909 4.19611 1.89612 -640 1 16.8064 12.5561 9.82402 0.581653 -6.91502 5.14494 -641 2 16.9779 11.8749 9.14515 -1.61791 10.9714 -1.54419 -642 2 16.8208 13.4318 9.41997 2.06437 -4.78596 -5.13994 -643 1 6.05928 2.9442 2.82556 1.25802 -7.30262 2.82421 -644 2 6.27309 3.83898 2.57954 7.79966 17.9541 1.71249 -645 2 5.71238 2.57735 2.0082 -4.75947 -10.8151 -3.84195 -646 1 10.8984 3.29285 3.29228 5.15622 -3.79068 5.20633 -647 2 10.3299 4.01236 3.59418 -0.748764 -1.25701 -6.51467 -648 2 10.5397 2.95527 2.46424 -5.70132 0.188995 -0.608043 -ITEM: TIMESTEP -30 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.74009 7.04233 17.938 19.1777 -3.19214 -7.49225 -2 2 7.80649 7.00854 18.1244 -14.093 -2.50808 3.42214 -3 2 8.91581 6.41795 17.2214 -5.10918 0.448792 4.2696 -4 1 18.6171 8.27942 6.83462 -12.32 14.9255 -3.46236 -5 2 0.0642234 8.14825 5.88022 8.8384 -8.96826 -1.74433 -6 2 0.471057 7.61284 7.31078 8.78566 -8.6497 2.36561 -7 1 8.41948 18.604 6.83196 -7.31709 9.89495 0.0475112 -8 2 9.31705 0.18142 6.57583 5.64527 1.22556 -0.782264 -9 2 7.87491 0.677395 6.4693 3.49499 -4.79599 0.294282 -10 1 6.58709 1.81441 11.6738 -9.76955 10.2882 13.9968 -11 2 5.91112 2.25954 12.2323 7.89399 -9.20897 -13.0604 -12 2 6.23103 0.933026 11.5157 -4.21921 -5.78552 -0.720022 -13 1 7.09426 5.71845 2.37594 5.34919 -15.1759 8.94595 -14 2 6.67772 6.26147 3.06365 -7.93287 1.62685 -13.8275 -15 2 6.91151 6.0744 1.49958 -5.30903 10.9181 0.766926 -16 1 16.2033 10.1932 16.1102 25.1038 -14.8345 -4.68499 -17 2 17.1811 10.2276 15.9712 -26.7737 6.31541 3.48142 -18 2 15.8826 11.0697 16.3304 -0.495148 7.87416 1.92317 -19 1 10.6275 14.9681 2.33481 4.63974 12.4061 -8.88569 -20 2 10.5525 14.5877 3.21874 0.475518 -3.93386 2.29786 -21 2 11.1735 15.7673 2.45016 -5.17002 -7.496 3.37274 -22 1 17.1558 8.25893 10.4932 -6.40301 -0.466841 8.61163 -23 2 16.8014 9.01233 11.0035 2.41501 -9.01393 -1.96838 -24 2 17.9838 8.5563 10.1014 3.2569 5.37409 0.738347 -25 1 14.813 15.8567 16.3841 0.422148 6.97991 -3.34819 -26 2 13.9021 16.1825 16.382 -1.86689 -1.60487 0.125842 -27 2 14.9304 15.3999 17.2268 -3.27081 -1.81494 5.72738 -28 1 12.1434 13.4089 0.461034 6.76243 -11.3039 1.90058 -29 2 12.0273 13.3364 18.1404 -4.47443 10.9984 5.76772 -30 2 11.5266 14.0334 0.870976 -2.78837 -1.53089 -3.65161 -31 1 9.27697 5.43199 4.02458 -7.91052 -7.29997 -7.2337 -32 2 8.84655 5.10212 4.83549 0.848683 4.58319 -8.36746 -33 2 8.59135 5.35221 3.31849 12.3251 4.32217 11.9863 -34 1 1.81829 4.21991 11.6429 6.07059 -17.107 12.3126 -35 2 1.72876 5.16246 11.8251 -3.56412 5.27463 0.970751 -36 2 2.25117 3.81723 12.4298 -6.51129 5.35444 -16.475 -37 1 2.00161 6.82001 8.34658 4.25884 -4.64897 6.26816 -38 2 2.3883 7.2423 9.12712 0.123274 4.2764 -6.11357 -39 2 2.06217 5.87963 8.57415 -6.89287 0.824976 -4.38383 -40 1 5.40511 4.42179 7.95561 5.36611 -11.1614 7.9457 -41 2 5.37943 3.4545 8.00651 8.07147 0.734095 -1.60012 -42 2 4.74745 4.62621 7.29567 -7.31573 12.7226 -8.35968 -43 1 3.27976 2.92717 17.5269 -2.61436 17.3567 -5.43199 -44 2 3.96706 3.40529 17.0145 -5.77518 -10.9103 1.73426 -45 2 2.73687 3.63363 17.9263 6.62302 -5.15647 1.61932 -46 1 7.46558 5.28438 6.08942 -8.18758 20.8516 25.3808 -47 2 7.86532 6.07017 6.49581 9.60667 -5.12281 -7.79846 -48 2 6.93507 4.98822 6.84771 -4.13165 -15.5457 -12.384 -49 1 9.77734 7.00329 11.9774 4.77277 1.25087 12.6605 -50 2 10.3838 6.43919 11.4894 -2.2356 -0.795019 -4.50196 -51 2 9.03042 7.20515 11.401 -0.391647 0.322053 -6.58611 -52 1 14.0794 3.58589 8.07965 12.1281 -3.68665 15.0324 -53 2 13.9224 4.24013 7.41233 -5.94016 13.6931 -8.832 -54 2 14.4997 4.05823 8.8235 -7.49262 -7.6028 -6.06268 -55 1 4.66909 17.2524 3.98463 -11.974 -6.63251 3.44703 -56 2 5.54996 17.5659 4.2137 3.76078 6.9996 -9.15965 -57 2 4.29017 17.6906 3.19701 6.52868 -0.394456 6.67531 -58 1 16.4992 16.6027 10.1206 -21.6924 9.71885 22.6747 -59 2 15.7868 16.8403 10.7484 14.9981 -6.02669 -3.77625 -60 2 16.0155 16.0666 9.49209 1.7904 -6.99745 -11.6514 -61 1 1.97502 4.88502 0.412911 -0.608987 3.87721 -1.07962 -62 2 2.72637 5.27959 0.897705 -7.05745 -2.41863 1.64934 -63 2 1.49341 5.65258 18.7073 9.30006 -4.776 -0.647009 -64 1 11.7125 13.3331 16.298 -5.19121 -16.9939 -9.12414 -65 2 11.2215 12.495 16.3147 -7.17559 5.00423 10.7559 -66 2 12.3053 13.159 15.554 3.20757 8.82206 0.62976 -67 1 10.1364 11.0457 16.9267 -8.25027 -0.64471 -2.79768 -68 2 10.5138 10.1546 16.8726 -0.811727 0.343111 1.84422 -69 2 9.16904 10.9405 16.8614 10.4447 -1.98124 -2.23602 -70 1 11.7196 17.4866 13.4532 0.688277 4.88805 11.3616 -71 2 12.4565 17.1915 12.9059 2.31052 0.20251 -3.63622 -72 2 11.8417 18.4468 13.5823 3.75325 -8.25615 -8.02045 -73 1 6.38436 9.31353 12.2227 -10.6166 9.98881 15.1897 -74 2 6.82973 8.96514 11.4526 14.2312 0.227315 -7.303 -75 2 6.92633 10.0292 12.607 -0.115112 -8.7725 -6.80594 -76 1 16.2215 12.7689 2.69197 14.2202 2.36446 -2.70282 -77 2 17.0315 13.2181 2.42332 4.27042 -4.81366 0.268886 -78 2 15.6299 13.4985 2.86911 -16.5638 6.55953 0.86202 -79 1 0.643858 12.5819 5.90471 10.4355 0.0636689 -1.96923 -80 2 0.972356 12.3928 5.01972 -0.601341 2.21783 -2.79245 -81 2 18.3387 12.6591 5.78833 -5.81166 2.35718 1.0682 -82 1 5.2154 16.4273 18.4533 5.05017 -7.28804 7.26993 -83 2 5.85096 15.759 18.1791 -0.38035 -3.88529 -12.2081 -84 2 5.53459 16.6741 0.678671 -3.42073 7.449 3.19712 -85 1 0.551654 7.64481 4.10641 16.2354 21.1246 -10.5626 -86 2 18.6183 7.98546 3.39603 3.07966 -1.83327 6.1622 -87 2 1.42708 8.08449 3.93576 -19.267 -16.5837 1.18512 -88 1 3.12227 8.91534 6.50802 24.2291 -0.585626 7.1452 -89 2 3.7382 8.63748 7.22391 -17.1573 3.17125 -13.7643 -90 2 2.22482 8.81583 6.82729 -5.68465 -1.73896 5.22193 -91 1 7.30086 10.3189 16.2323 -15.6545 -0.122126 6.34207 -92 2 6.59019 10.5178 15.6183 5.33711 0.792532 -4.64 -93 2 6.81196 10.2023 17.0683 9.00195 1.1125 -0.831229 -94 1 11.1139 1.03369 5.01342 4.3303 1.68398 -12.6705 -95 2 11.3068 1.80352 4.46111 -2.07011 7.18197 9.97137 -96 2 10.7762 0.428462 4.34613 -4.44642 -9.51924 3.00218 -97 1 4.39584 2.7383 13.2149 -0.390466 4.89753 -17.2666 -98 2 4.70663 3.24132 13.9776 -1.24631 -10.9908 10.3904 -99 2 4.24133 1.79775 13.4334 4.65854 7.0575 9.14841 -100 1 8.38523 10.0971 1.80824 -1.28714 19.1329 -0.644156 -101 2 8.30354 10.8052 2.48172 0.822207 -7.93375 -7.37013 -102 2 8.79223 9.36658 2.27287 1.71369 -9.23717 4.71722 -103 1 10.4729 1.73916 15.5717 11.6995 -6.53653 -13.4069 -104 2 11.3877 1.45477 15.4183 -5.50109 4.13915 12.9036 -105 2 10.2466 2.11684 14.7151 -9.31794 0.949785 -3.28817 -106 1 2.72932 12.8923 7.77007 2.13638 -2.03638 4.95693 -107 2 3.24355 13.6603 7.47881 -3.48119 -3.6232 -2.9431 -108 2 2.14523 12.6528 7.03806 -2.13852 4.70731 1.87174 -109 1 3.67999 11.6951 5.25129 1.06179 2.30609 -7.65488 -110 2 3.48397 10.8814 5.71277 1.07183 -5.39866 6.20843 -111 2 2.98047 11.7882 4.59744 -0.426908 3.81831 -2.62473 -112 1 6.82829 14.472 16.8976 7.24547 -11.7087 -0.510459 -113 2 7.70535 14.0752 16.845 -3.98439 5.03843 1.85271 -114 2 6.50852 14.4918 15.986 -3.30226 9.38599 0.302494 -115 1 14.1912 14.5549 3.37889 -4.65321 -1.5346 -2.40618 -116 2 13.6567 15.3531 3.27958 4.16996 -0.562804 -5.50008 -117 2 13.6356 13.9417 3.87468 5.16163 -0.564442 6.07906 -118 1 8.32326 18.1549 16.0383 38.0123 0.723105 5.33509 -119 2 8.90126 17.4596 16.3629 -14.277 -18.5473 4.85232 -120 2 9.02384 0.130446 15.7883 -15.867 17.9211 -5.43461 -121 1 4.72767 1.62379 4.93271 -17.6379 -0.985038 1.9521 -122 2 3.81401 1.95679 4.84992 11.4813 -1.52324 3.97162 -123 2 5.23321 2.13073 4.30096 3.99283 5.81443 -10.8958 -124 1 15.0185 12.7583 16.4307 33.5549 -15.7429 -8.88385 -125 2 14.6322 13.2399 17.156 -17.5625 6.9837 5.99474 -126 2 14.4538 12.6352 15.6516 -10.3238 6.55553 8.00439 -127 1 15.7718 18.4254 16.841 -12.0797 -5.1952 -2.21012 -128 2 16.3284 18.515 17.6327 0.946096 -4.9786 -5.09166 -129 2 15.4084 17.517 16.8347 11.7053 8.22526 2.07191 -130 1 1.18057 1.17309 16.5558 11.0398 2.91722 -0.500753 -131 2 1.84524 1.84688 16.7601 6.86303 -5.43895 -3.7977 -132 2 0.618264 1.22767 17.321 -11.8887 1.06625 6.89733 -133 1 18.1125 4.54155 15.913 0.560198 2.18648 6.37111 -134 2 18.4591 4.08913 15.1466 2.75843 -6.08521 -5.17788 -135 2 18.7597 4.4472 16.6204 -1.36812 0.49592 -3.69459 -136 1 12.2402 16.9779 16.1352 2.31512 -6.99762 -15.3414 -137 2 11.5952 16.4515 16.6081 -8.3163 0.999648 8.5775 -138 2 12.0081 16.8315 15.1982 2.22798 9.47321 6.13039 -139 1 15.9623 2.53119 18.0207 2.93621 -4.28086 -0.122131 -140 2 15.5695 3.22825 18.5544 -2.43998 7.63429 -5.2422 -141 2 15.6676 2.68289 17.1026 2.19807 1.36349 7.25858 -142 1 6.70368 13.8359 10.2288 1.24588 -18.109 -1.49583 -143 2 6.57782 13.5214 11.1319 -1.51171 6.96132 4.85856 -144 2 6.68827 13.0063 9.72453 -2.19505 9.55036 -5.72862 -145 1 10.1309 18.2871 2.76796 -14.3596 -6.47533 0.342864 -146 2 10.2029 0.342366 2.11266 2.51428 7.52943 -3.11917 -147 2 9.22516 17.9366 2.63576 15.7336 3.88756 2.50188 -148 1 2.99532 17.7363 6.09725 27.6457 -0.367768 9.57951 -149 2 2.17297 17.7876 5.61616 -10.9588 -3.8104 -13.5012 -150 2 3.724 17.7747 5.44639 -16.7072 2.57282 0.579206 -151 1 12.5761 16.9143 8.00615 -13.9856 15.3012 3.95273 -152 2 11.7456 16.4539 7.8426 4.73348 -10.9119 -5.17088 -153 2 12.3021 17.5765 8.66814 13.2598 -3.61726 -0.932189 -154 1 14.882 15.2803 8.24971 10.681 -0.761738 -5.80123 -155 2 14.3225 16.029 8.07669 -22.8014 8.12514 9.31404 -156 2 15.4227 15.298 7.45407 7.11517 -7.78554 -3.15381 -157 1 17.6329 18.2578 0.365715 -0.853361 22.9802 4.00517 -158 2 18.5235 17.9699 0.161776 5.93848 -16.2402 -3.481 -159 2 17.7627 0.512218 0.708086 -5.13428 -6.58263 -1.39758 -160 1 0.88251 10.4012 1.38524 10.7451 13.2218 -5.20703 -161 2 0.0659506 9.93794 1.52098 -14.8693 -14.1338 10.0664 -162 2 0.630973 11.1288 0.804044 1.28572 5.25949 -2.19783 -163 1 1.64115 12.2217 3.35193 -3.18006 -13.1055 -18.8251 -164 2 1.37082 11.5062 2.75067 2.88651 -5.3868 11.6868 -165 2 1.67765 12.9428 2.72371 4.09986 15.3051 6.03005 -166 1 0.58147 17.2398 4.87485 -10.389 -0.219728 20.623 -167 2 -0.122589 17.8866 4.86961 1.40048 11.6397 -9.93657 -168 2 0.410626 16.8027 5.7206 11.49 -10.3372 -7.14723 -169 1 1.11352 0.964392 9.43077 -4.94184 3.64088 -20.8453 -170 2 1.20387 0.588778 10.3126 -0.847456 -3.79009 5.67247 -171 2 0.226103 0.72639 9.1141 8.25621 -1.04795 9.52173 -172 1 16.7603 2.33922 13.2874 -3.33679 -13.7714 7.5216 -173 2 16.8475 2.59005 12.3669 3.49604 3.27514 -7.50745 -174 2 16.539 1.38388 13.2956 1.74648 12.4468 1.52133 -175 1 2.56382 15.8252 12.169 -1.32309 5.18512 -19.2115 -176 2 3.14843 15.408 12.7949 3.95332 -3.2625 9.96296 -177 2 3.02181 15.7534 11.31 -3.03818 -3.40517 4.91625 -178 1 16.4251 15.6276 5.98753 2.75225 -2.61515 5.58966 -179 2 17.3447 15.6415 6.33695 -10.8386 4.94036 -7.12539 -180 2 16.2312 16.4474 5.48017 12.4296 -10.8984 6.26847 -181 1 5.80144 5.06794 11.7894 5.49032 -3.99323 1.93812 -182 2 5.42192 5.63452 12.4754 -2.65214 7.25607 -4.62846 -183 2 5.38258 4.20716 11.9011 -4.64894 2.39601 -1.00669 -184 1 15.1781 4.86184 0.728524 -4.34825 6.76152 14.6306 -185 2 15.2668 4.67158 1.68153 -8.60174 -1.32446 -9.75027 -186 2 14.3367 5.34751 19.2902 10.4034 -8.61994 -3.37533 -187 1 16.3306 16.3549 2.10387 -3.60874 -8.17165 19.4202 -188 2 16.1436 16.7757 2.96383 0.821724 -8.86269 -6.10473 -189 2 16.4161 17.1032 1.53428 7.22132 12.8567 -17.8694 -190 1 0.267773 4.86229 3.80408 10.7738 -14.2237 3.39069 -191 2 0.48911 5.8014 3.76313 1.80944 1.44211 5.87769 -192 2 1.0394 4.38382 4.18029 -13.1099 14.4171 -4.44332 -193 1 2.95694 15.0447 15.0954 -6.10325 -16.3486 9.96696 -194 2 2.71126 14.628 15.9563 6.59243 11.9398 -10.1751 -195 2 2.48371 15.8886 15.0723 0.827451 0.569437 4.39106 -196 1 1.13642 14.6155 9.54099 -48.9591 -6.29818 10.1377 -197 2 2.0574 14.6763 9.37448 31.1561 -9.052 1.81392 -198 2 0.917533 13.7788 10.0133 17.9146 13.2649 -10.59 -199 1 13.6267 16.618 11.5309 -14.0517 -2.94194 4.54584 -200 2 13.2284 17.3872 11.0909 1.36391 -4.96948 -3.72009 -201 2 13.0435 15.8681 11.2876 10.4622 6.11411 -5.34277 -202 1 4.69594 1.47637 0.748111 -12.1621 -0.739309 -0.414133 -203 2 4.0907 2.00679 0.20438 8.77888 0.173625 -0.66482 -204 2 4.10511 0.858084 1.19895 3.99089 -4.2391 -0.703649 -205 1 1.43799 18.5334 11.8677 4.48354 -19.5441 -2.70285 -206 2 1.28309 0.34807 12.6964 -2.38454 7.77338 6.6957 -207 2 1.65634 17.6099 12.1011 0.514199 12.3996 -0.852918 -208 1 11.5339 10.1172 4.0507 5.82948 9.6286 -18.4863 -209 2 11.2843 10.5321 3.18756 5.15824 -8.38498 16.2271 -210 2 12.5124 10.093 4.04255 -10.5657 0.881913 4.0585 -211 1 8.32129 12.1582 3.72502 1.53352 8.77417 8.44763 -212 2 9.09494 12.6645 4.01218 5.78128 -3.64141 -7.92941 -213 2 7.76311 12.2518 4.50437 -12.3191 -3.17133 -0.801295 -214 1 14.3738 4.02512 3.28302 13.4457 8.56362 13.3606 -215 2 15.0833 4.15474 3.94873 -8.39321 -4.82495 -4.85792 -216 2 13.6328 4.57269 3.59478 1.91801 -3.79011 -4.78214 -217 1 5.59001 1.69403 7.5104 -22.1497 -9.71937 -16.3739 -218 2 4.92965 1.04535 7.86703 17.0022 15.2682 -3.23125 -219 2 5.33019 1.76513 6.54994 10.6546 -4.2597 24.8978 -220 1 17.8762 1.11593 4.87562 6.9502 3.59021 1.61777 -221 2 18.6375 1.36949 4.33979 -2.23157 -1.53514 -7.48501 -222 2 17.9489 1.70322 5.63717 -7.55192 -1.12522 1.72169 -223 1 6.82082 9.41417 4.48467 7.28036 -1.61815 9.25922 -224 2 6.87733 9.61398 5.42883 -5.7945 0.587378 -0.0554941 -225 2 7.74179 9.22243 4.26363 -0.0627487 -3.5933 -6.80471 -226 1 2.67079 14.9403 1.9639 10.8093 -10.5544 22.1131 -227 2 3.25117 14.6591 2.70117 -12.0207 4.93014 -5.95014 -228 2 3.29732 15.1077 1.27121 3.13815 4.27624 -15.5237 -229 1 17.3067 12.913 13.1683 10.6019 -31.6629 4.62367 -230 2 16.4497 13.2737 13.3972 -3.78483 16.2252 -3.80314 -231 2 17.8834 13.5891 12.8053 -8.28955 15.595 1.58636 -232 1 14.9867 10.5664 1.39303 17.3246 -3.28745 6.09509 -233 2 15.5958 11.2392 1.752 -7.58668 -4.78908 -2.0363 -234 2 14.1528 11.003 1.29225 -13.717 8.26159 -1.38466 -235 1 5.69708 6.86241 4.54741 10.2551 2.99419 0.383868 -236 2 6.12873 7.74081 4.58523 -8.39477 -7.3362 -0.690872 -237 2 6.29159 6.23392 4.98874 0.140081 3.89587 3.34658 -238 1 8.04621 8.27418 10.2318 -1.25624 6.00125 -7.48209 -239 2 8.67166 8.94213 9.92965 6.80147 7.39227 7.14523 -240 2 7.62794 8.03247 9.40376 -7.32264 -11.607 2.12748 -241 1 13.4746 18.3625 5.78211 -13.502 7.51331 -2.26288 -242 2 12.7551 0.364455 5.61988 6.67968 -8.24018 -2.37745 -243 2 13.1168 17.8207 6.50434 6.50164 -0.829271 0.111391 -244 1 0.226362 2.58719 0.131375 -15.5932 24.0028 11.6326 -245 2 17.9693 2.93929 18.6394 3.5786 -16.3529 -5.12341 -246 2 0.708035 3.3711 0.44675 7.58398 -8.21165 -4.7522 -247 1 12.703 11.0237 9.75181 24.9284 -7.65781 8.94422 -248 2 11.7937 10.9936 9.46616 -11.7502 -8.38149 -1.23796 -249 2 12.9608 10.1029 9.99094 -10.5021 9.57622 -2.72207 -250 1 0.761974 12.2205 11.0816 -4.15363 -6.09516 -21.355 -251 2 18.4366 12.288 11.0674 3.38909 -0.754442 8.49561 -252 2 1.11175 12.4338 11.9478 -3.68194 5.91832 8.04416 -253 1 5.07253 7.26896 13.4467 3.90397 -0.0234352 3.77117 -254 2 5.61152 7.96046 13.0436 -1.11485 3.21213 -6.58832 -255 2 5.53238 7.13074 14.2827 -1.05457 -4.33313 3.81413 -256 1 1.23629 6.9109 11.8337 28.2892 12.95 23.6673 -257 2 0.51347 7.34016 11.3984 -13.736 7.24235 -8.87687 -258 2 1.75935 7.64669 12.2495 -13.9201 -17.9067 -15.9983 -259 1 15.4873 9.53008 12.3182 -0.383493 4.12812 -8.89679 -260 2 15.0655 10.399 12.2152 3.51435 -2.6855 7.45914 -261 2 15.2649 9.14784 13.1724 -1.90612 6.52608 2.19385 -262 1 16.6085 12.8345 5.46896 -3.55761 11.1023 -1.95777 -263 2 16.4419 13.7896 5.48874 0.313493 -0.193839 12.6146 -264 2 16.4475 12.6632 4.54137 -0.0496347 -14.7353 -8.15109 -265 1 6.20534 9.98194 0.0899104 18.0768 -8.37359 0.258846 -266 2 5.59572 10.4068 0.70246 -2.59094 3.74961 3.89273 -267 2 7.08249 9.9872 0.527613 -14.0474 2.02387 3.58276 -268 1 12.3397 6.07843 4.05984 1.81271 11.939 -8.21694 -269 2 12.2328 6.8085 3.41842 8.48996 -4.45606 3.14495 -270 2 11.4615 5.7138 4.10837 -10.8447 -6.35959 3.05037 -271 1 0.186481 12.7968 0.194157 8.45417 -0.362633 0.823389 -272 2 0.122538 13.4857 0.868002 -3.08717 1.48078 1.57348 -273 2 18.4164 13.184 18.057 -2.66731 -2.48236 -4.34426 -274 1 3.77162 18.5917 8.57827 -20.4554 1.45559 2.68175 -275 2 3.52322 17.9715 7.87805 6.33007 3.25639 -1.82086 -276 2 2.90938 0.367014 8.76804 7.74592 -0.0744794 5.639 -277 1 7.46409 17.2961 4.48316 -14.1198 -17.2275 8.02552 -278 2 7.88946 18.1398 4.59819 4.06261 16.9953 -5.43573 -279 2 7.32948 17.1504 3.54137 6.62361 8.1702 -3.03871 -280 1 9.24056 17.0796 12.2607 -1.29913 -0.841935 -6.42698 -281 2 9.19718 16.4258 11.5387 7.57092 0.344645 9.78983 -282 2 10.1052 16.9888 12.7016 -6.07497 2.05659 -6.06408 -283 1 13.326 12.928 7.96212 4.69357 25.6567 2.07593 -284 2 13.3763 12.2768 8.65803 -4.91574 -13.7878 2.50151 -285 2 13.7353 13.7181 8.35204 8.56042 -2.58857 -8.38859 -286 1 14.9538 2.97298 15.3382 -4.29462 -11.8182 -2.96981 -287 2 14.4639 2.15222 15.1644 -2.78402 11.1896 3.17375 -288 2 15.6292 2.97829 14.6488 1.75 3.70602 0.0805282 -289 1 9.85487 15.5414 16.9955 1.72232 -1.82893 -0.169847 -290 2 10.3837 14.7676 16.7382 -3.42626 -0.271454 1.71497 -291 2 9.29261 15.2923 17.7497 4.44449 2.55726 -1.27949 -292 1 11.3089 8.30526 16.5494 -6.04997 -6.2326 7.21044 -293 2 10.5881 7.89563 16.0543 2.01853 1.78394 -3.12513 -294 2 11.4835 7.65722 17.2517 2.74023 7.81545 -1.84368 -295 1 3.836 18.1836 16.7517 -7.13385 -19.1452 -23.0441 -296 2 4.27407 17.4593 17.223 1.84106 9.67264 7.83483 -297 2 3.88222 0.348533 17.2402 4.94653 11.64 14.7969 -298 1 2.18178 4.13609 8.93005 8.1701 -0.774865 9.73019 -299 2 3.0913 3.90524 8.75773 5.46766 -1.37508 -11.1104 -300 2 2.14869 4.01328 9.88774 -11.2166 4.12208 2.959 -301 1 9.87742 10.3647 9.70242 2.63105 14.1486 10.9213 -302 2 9.56679 11.2208 9.35298 -0.359428 -9.80694 -0.658425 -303 2 10.1334 10.5423 10.6269 -4.00587 -8.10964 -6.10976 -304 1 9.70429 0.823826 10.8553 -14.0108 4.16215 1.0267 -305 2 9.1278 18.77 11.1938 11.0832 -7.32823 7.11532 -306 2 9.14207 1.22722 10.1856 4.51331 8.02138 -6.87563 -307 1 9.20617 15.1402 10.2178 -11.609 -5.72992 -0.101326 -308 2 8.7465 15.767 9.6415 2.03963 4.50002 1.17892 -309 2 8.51696 14.4821 10.4282 6.2553 7.07807 -5.66984 -310 1 0.996164 9.40777 10.3157 -31.4617 35.4735 1.80375 -311 2 1.02993 10.3821 10.3914 -11.0752 -10.4846 4.01107 -312 2 1.89609 9.22017 10.2201 37.6387 -20.6805 -6.1303 -313 1 16.8786 4.85128 8.17759 -11.2506 16.3288 -5.48708 -314 2 16.2388 5.56314 8.38188 8.44756 -9.04525 0.78656 -315 2 16.9626 4.34108 8.98054 4.36808 -7.38136 2.74573 -316 1 14.6815 14.711 0.319263 14.4838 0.937126 -3.06264 -317 2 15.2721 14.9301 1.06391 -7.87321 4.75235 -6.44468 -318 2 13.8763 14.3724 0.714255 -5.91657 -4.41648 2.02008 -319 1 3.57415 11.0448 9.58418 2.91679 3.40936 2.58946 -320 2 3.69173 11.5263 10.4228 -3.34733 -6.02301 -1.37626 -321 2 3.07399 11.6483 9.00652 3.80152 0.245021 0.575116 -322 1 11.1013 10.8086 1.33492 -13.1151 -1.75228 0.351043 -323 2 11.4484 11.639 0.990604 2.68761 3.85867 -0.677593 -324 2 10.1644 10.7789 1.04773 13.6271 -2.80152 6.25142 -325 1 13.1828 7.11823 12.837 13.875 6.93007 -2.08809 -326 2 14.1546 7.00576 12.8731 -8.73741 -0.33434 -1.11439 -327 2 12.8407 6.21951 12.8306 -5.12621 -6.60309 0.0889066 -328 1 9.62491 1.88499 0.973614 -3.42399 -6.06492 -12.2684 -329 2 8.82152 1.4846 0.597998 2.34171 8.22807 3.07369 -330 2 10.1781 2.12743 0.21359 -0.384483 0.556473 6.61436 -331 1 10.6031 13.5334 4.66686 13.636 -3.8461 -1.22567 -332 2 11.4763 13.1252 4.55872 -4.58351 -5.15517 0.0143246 -333 2 10.7077 13.9241 5.53959 -7.66657 9.10334 4.04553 -334 1 14.3485 1.75735 10.9256 -1.10429 -17.7549 1.09656 -335 2 15.1861 1.44338 10.54 -2.80824 6.90847 2.1648 -336 2 14.3834 2.71874 10.9625 8.08978 3.11888 -5.0019 -337 1 14.6333 12.3432 11.6996 -1.39952 -9.16637 -24.1357 -338 2 15.3681 12.4502 11.0746 9.0546 4.11007 14.4837 -339 2 13.9355 12.122 11.0753 -11.0061 -2.1546 9.49113 -340 1 8.24004 5.06512 9.81661 -6.73852 -15.0928 -6.1646 -341 2 7.43321 5.24609 10.2868 -7.68507 10.8263 10.6715 -342 2 8.07004 4.14881 9.53169 13.9201 5.19095 -3.88371 -343 1 1.57861 16.855 18.3455 -3.6047 -18.8696 23.6299 -344 2 1.81992 17.2862 17.5419 10.6717 7.49965 -18.3027 -345 2 1.88846 15.9289 18.2434 -7.51751 10.9825 -1.36554 -346 1 1.48469 17.2399 15.3369 -30.5992 8.85894 1.58219 -347 2 1.52903 18.0991 15.7763 5.64601 2.15314 -3.36931 -348 2 0.515015 17.0623 15.2815 21.6878 -4.25813 -0.913042 -349 1 3.6961 5.66103 6.13276 1.27154 -4.68408 -0.174538 -350 2 3.02861 6.15393 6.634 5.94065 6.05513 -0.564102 -351 2 4.2706 6.29315 5.66099 -8.13711 -1.6893 2.05746 -352 1 12.3863 9.46112 14.1898 5.64676 -22.9439 1.72589 -353 2 12.6155 8.61212 13.7476 3.53191 14.2422 4.21489 -354 2 12.2183 9.16782 15.1036 -0.67103 6.17556 -4.58111 -355 1 4.03262 15.2884 6.88962 -6.96122 -2.16466 3.53978 -356 2 3.61008 16.076 6.4989 3.67472 -5.21865 6.04109 -357 2 4.98914 15.3892 6.82497 3.29203 7.08348 -5.36605 -358 1 0.610585 8.57451 14.9167 2.06858 8.16468 9.66942 -359 2 0.571526 9.5334 15.101 -0.509723 -6.74541 -4.80249 -360 2 1.24768 8.49017 14.2004 3.24343 3.39805 -1.00154 -361 1 12.9947 8.30502 10.3347 -2.10898 5.96297 -3.02925 -362 2 13.7245 7.79451 9.98073 4.34503 -3.62623 -11.9067 -363 2 13.0194 8.04092 11.2546 -7.35013 -0.655157 9.61409 -364 1 15.3021 7.68636 3.53463 20.0464 32.042 -6.64886 -365 2 14.6007 7.2355 3.06802 -7.18972 -17.1123 8.01585 -366 2 15.7144 7.29713 4.32433 -16.1768 -11.7678 -0.766084 -367 1 17.3034 6.68003 0.0493874 -1.84179 -13.5509 -2.88881 -368 2 16.9519 5.78424 0.161568 0.711034 6.10552 3.25575 -369 2 16.5083 7.2036 18.5276 -0.473138 7.46776 -7.84911 -370 1 8.84315 6.93181 7.84628 -0.943806 11.0529 -13.3888 -371 2 9.77771 7.20927 7.80441 -6.03996 -2.82935 4.46193 -372 2 8.74315 6.27043 8.54219 4.24547 -3.80386 5.92931 -373 1 12.3578 0.616451 1.20223 7.02437 -6.39463 -1.478 -374 2 13.2861 0.535705 1.47006 -5.02329 6.70293 3.96338 -375 2 12.2631 18.6802 0.444477 -1.70715 1.25222 -1.43865 -376 1 5.64724 15.135 14.5406 -0.604856 -11.7009 0.79572 -377 2 4.70142 15.1669 14.7844 5.92695 5.15448 -4.69419 -378 2 5.94602 16.0188 14.2721 -2.36621 0.047849 -2.09121 -379 1 3.86203 6.47491 1.73695 1.36817 -0.22553 5.39386 -380 2 3.46749 7.3178 1.48065 -2.80916 3.79134 -8.60259 -381 2 4.09027 6.61791 2.66801 -1.52617 -4.74348 -3.78665 -382 1 3.89615 11.6258 12.3135 -4.96985 -7.23752 -2.42851 -383 2 4.76636 11.9561 12.5635 2.33504 5.86151 0.242199 -384 2 3.23901 12.1927 12.7515 8.69891 -3.88643 -0.482475 -385 1 5.40213 3.8611 15.8693 10.8945 -12.2769 2.09816 -386 2 6.15363 3.21949 15.8699 -18.4435 12.0745 -5.1575 -387 2 5.79254 4.73962 15.8533 3.23601 3.32406 0.742539 -388 1 14.4255 10.2871 4.42158 -5.00773 -17.9107 13.5675 -389 2 14.5181 9.70279 5.20492 2.69814 10.8256 -8.91808 -390 2 14.7837 9.77905 3.68069 -0.206993 2.85241 0.289205 -391 1 7.87167 17.3723 9.20121 -10.8695 6.25183 -3.73994 -392 2 7.03582 17.6433 9.5986 1.28641 -7.15132 6.24862 -393 2 7.9635 17.9776 8.45108 8.3983 -5.79413 -1.77097 -394 1 4.52981 14.473 3.9851 -7.27149 14.4717 16.1092 -395 2 4.4292 15.3844 4.34508 5.86047 -13.4028 -12.5476 -396 2 4.51094 13.8931 4.76638 0.622359 -0.721789 -7.97238 -397 1 14.2548 7.40188 15.768 -9.88191 3.80355 1.83721 -398 2 15.2055 7.32768 15.6782 10.3356 -1.93634 -2.70959 -399 2 14.1214 7.72007 16.6658 2.42251 2.42868 0.921806 -400 1 2.92318 18.2319 1.90056 8.21916 -2.84793 -3.01579 -401 2 2.38261 17.6158 1.3774 3.82694 3.92633 -2.29165 -402 2 2.32657 18.895 2.2462 -10.4983 4.84254 7.82145 -403 1 7.9872 1.59624 4.55123 -13.2342 7.82044 -5.09514 -404 2 7.38456 2.15817 4.04087 -4.12207 -9.74777 1.09289 -405 2 8.829 1.94177 4.28864 19.9647 -0.586446 1.64736 -406 1 2.52886 14.1331 17.7106 9.56011 -8.28606 7.0204 -407 2 2.01365 13.3855 18.0679 -1.20108 10.5585 -3.23507 -408 2 3.45026 13.9294 17.9721 -7.58546 -2.42865 -2.00823 -409 1 0.784808 1.71729 13.877 -22.3729 3.14932 11.7627 -410 2 0.820241 1.39718 14.7912 6.0833 4.21121 -6.47959 -411 2 18.4913 1.99435 13.7832 17.5446 -4.15928 -6.69512 -412 1 4.49906 18.6473 13.9354 -18.7945 1.8826 8.61585 -413 2 5.41644 18.4141 14.0419 11.9469 -5.27484 -6.26214 -414 2 4.07897 18.3597 14.7657 2.79866 5.45516 -5.58976 -415 1 7.09283 0.599142 18.3486 34.6471 -4.12786 -6.63011 -416 2 7.39021 0.234617 17.4878 -9.84259 3.28252 9.67216 -417 2 6.14438 0.553251 18.3894 -16.3447 5.16139 0.014819 -418 1 16.0881 18.4309 14.0453 5.06229 7.716 24.0321 -419 2 15.2482 18.0804 13.8032 -16.2536 -8.6858 -12.6141 -420 2 15.9952 18.587 15.0073 9.58514 -0.127307 -10.5143 -421 1 10.0776 4.50678 16.2676 12.8821 37.0646 3.31891 -422 2 10.9819 4.89306 16.3611 -10.6263 -20.5161 -3.34059 -423 2 10.1424 3.55939 16.3223 6.24363 -16.5382 -1.58612 -424 1 15.8992 17.8398 4.41934 12.2004 7.51097 -4.98004 -425 2 16.3832 18.6941 4.42415 -3.71288 -10.9395 3.02327 -426 2 14.9903 18.0494 4.62819 -9.96916 6.21932 6.5896 -427 1 6.98832 17.3871 13.7576 13.6855 5.49553 14.8404 -428 2 7.37965 17.5993 14.631 -4.71479 -0.449691 -14.3122 -429 2 7.76575 17.2997 13.1656 -13.1106 -1.1113 5.84114 -430 1 13.2824 6.5097 6.67953 4.56939 11.9611 -5.54075 -431 2 14.0532 7.04843 6.47095 5.72005 -2.26771 11.4806 -432 2 12.9258 6.37058 5.8058 -10.6331 -8.36185 -8.97535 -433 1 7.75109 2.3756 9.23631 -5.33505 -3.40336 15.3372 -434 2 7.18759 2.24157 10.0186 8.87424 2.78019 0.355864 -435 2 7.20141 2.0575 8.52046 -4.61968 -0.366971 -12.063 -436 1 15.1734 14.8403 13.6669 0.441467 -1.73197 5.96822 -437 2 15.0738 15.2212 14.5455 0.591215 -4.0348 4.14746 -438 2 14.518 15.2716 13.122 -1.09719 2.73458 -8.10719 -439 1 9.35119 8.31644 3.739 2.66762 7.66889 5.69365 -440 2 10.15 8.71947 4.13947 -5.98752 -7.29531 -6.80605 -441 2 9.38201 7.35632 3.87197 4.69073 2.10751 1.74529 -442 1 17.751 13.5231 16.4139 1.76506 1.52762 0.696064 -443 2 16.8205 13.2419 16.3833 1.32585 7.25436 -2.93419 -444 2 17.8025 14.3962 15.9827 -4.54797 -4.37418 0.927992 -445 1 4.99908 10.6417 2.69781 -10.2301 11.821 9.59097 -446 2 5.61637 10.2237 3.29708 11.0389 -6.03173 2.08237 -447 2 4.70065 11.4181 3.20566 0.509198 -9.80178 -10.0294 -448 1 3.73671 8.33589 10.2301 0.811909 12.56 -11.1256 -449 2 3.79833 9.26935 9.95307 1.30999 -3.93497 -1.66187 -450 2 3.73931 8.38186 11.1831 0.045476 -4.76093 8.99044 -451 1 16.0469 7.05349 6.21752 -8.36922 7.98368 -7.54927 -452 2 16.8656 7.47651 6.4961 3.44749 0.07849 4.67395 -453 2 16.1438 6.1088 6.32704 6.52122 -4.4821 -3.05144 -454 1 15.1289 7.04368 9.08785 10.4694 9.8467 1.75835 -455 2 15.8264 7.38614 9.67453 -3.18259 -3.19274 -6.50653 -456 2 15.1274 7.66298 8.34243 -1.48772 -3.73631 0.00250057 -457 1 6.37899 13.0555 12.8241 7.15095 -9.93714 4.62427 -458 2 7.14263 12.6042 13.2293 -5.49135 0.351509 -10.6671 -459 2 6.23455 13.8287 13.3737 -7.10156 7.81238 6.40695 -460 1 12.1361 4.49173 13.0886 -33.3605 -9.49617 -7.12831 -461 2 12.0495 4.6518 14.0281 12.9755 3.95225 11.8447 -462 2 11.274 4.06082 12.879 23.5373 6.19102 -2.9945 -463 1 11.3516 8.18262 7.87035 -14.4325 7.02786 -3.11936 -464 2 12.0471 7.65769 7.46008 8.6713 -7.43794 3.47117 -465 2 11.5359 8.26397 8.81258 10.0684 -2.50636 2.15934 -466 1 17.1915 10.8124 7.44959 -16.1176 10.6393 13.8832 -467 2 17.9047 10.1798 7.28217 -0.931293 1.13858 -10.0543 -468 2 16.9855 11.3827 6.68215 10.1883 -6.89581 1.62445 -469 1 5.25104 18.1119 11.0466 -2.03712 6.82198 -5.53245 -470 2 4.55844 17.9395 11.7023 5.22213 1.54215 -0.259713 -471 2 4.79647 18.4173 10.2467 -3.05137 -7.80568 1.06144 -472 1 7.59144 17.5428 1.82585 2.02366 6.3387 -27.4892 -473 2 7.8094 16.7742 1.27336 1.17923 0.135637 10.7354 -474 2 7.55288 18.254 1.15356 -7.65387 -5.36774 12.2151 -475 1 1.92063 12.9184 13.6023 -9.91855 -8.75107 -5.23832 -476 2 1.37345 12.2779 14.0844 5.59931 4.65398 4.03533 -477 2 2.08932 13.6638 14.189 3.88592 4.92281 2.07481 -478 1 9.68002 6.79239 14.8375 -5.9785 1.55821 1.53848 -479 2 9.8605 5.87105 15.0454 -1.79232 -6.14635 7.43903 -480 2 10.0701 6.92553 13.9753 -0.129146 4.69231 -11.1498 -481 1 15.2463 4.32976 10.758 3.34542 15.1712 12.775 -482 2 16.1952 4.27653 10.855 10.1577 -17.3864 -7.84826 -483 2 15.0718 4.96713 11.4544 -13.5892 3.80238 -1.28771 -484 1 11.2223 6.14234 0.184515 14.935 15.986 0.702496 -485 2 11.3427 5.2537 -0.179589 -9.34658 -3.11564 3.17557 -486 2 10.3073 6.45674 18.8196 -5.33379 -13.1911 -7.29958 -487 1 0.101128 11.3538 15.0994 -20.5112 19.1646 -16.3994 -488 2 18.0631 11.5965 14.4157 17.8209 -6.40715 11.0417 -489 2 18.7281 12.1498 15.6639 -2.69532 -11.5931 2.167 -490 1 7.07341 9.21118 7.26397 13.6545 -4.38359 1.14819 -491 2 6.46912 8.52168 7.54812 -6.91606 -6.22713 3.38737 -492 2 7.94495 8.78194 7.35853 -7.81842 8.24868 -3.32543 -493 1 18.379 15.4045 12.3485 -3.73833 -6.55761 4.14497 -494 2 0.693581 15.4288 12.2501 6.70794 3.85833 -5.56408 -495 2 17.998 15.8269 11.5664 0.97425 0.444703 -1.66759 -496 1 16.5516 4.36462 5.23826 -5.38189 5.67955 -17.8631 -497 2 16.655 4.28498 6.19256 13.2509 -4.37544 3.08954 -498 2 17.3965 4.59413 4.7818 -8.47419 -6.89051 15.5314 -499 1 17.7443 3.09877 10.7286 3.04827 -10.7181 -6.87848 -500 2 0.0283995 3.26624 10.9392 2.02267 5.05617 3.97045 -501 2 17.7464 2.2027 10.3321 -6.96828 10.7891 3.50943 -502 1 12.2779 0.0212452 10.1338 -0.475788 -3.12763 3.03365 -503 2 11.45 0.377358 10.5143 6.17492 -0.459139 -6.32122 -504 2 12.9469 0.721114 10.1609 -4.48032 5.31969 3.75096 -505 1 10.3747 9.79435 12.3975 0.995366 2.64477 2.84838 -506 2 11.0916 9.86004 13.0462 0.88472 -0.940912 -1.26785 -507 2 10.2331 8.84374 12.2815 -0.892889 0.226532 -0.81052 -508 1 0.549483 2.84316 7.02126 -1.47246 -21.9217 -16.5589 -509 2 0.577314 3.5439 7.66737 3.67317 4.63089 12.4819 -510 2 0.765862 2.00117 7.45653 1.04632 13.6877 4.9994 -511 1 0.405258 15.2829 6.93023 -2.49907 -5.43649 4.98244 -512 2 0.538371 14.8975 7.8327 2.16571 9.44122 -16.3162 -513 2 0.725684 14.6278 6.28848 -1.93707 -3.30699 10.9749 -514 1 17.0129 7.01771 15.2646 8.6122 -7.5627 -5.22629 -515 2 17.8138 7.53109 15.1273 -3.20292 15.4854 -2.58719 -516 2 17.4051 6.15342 15.4314 -10.2841 -6.73634 6.86556 -517 1 9.05466 12.4444 8.11302 13.0521 -10.4864 -20.5516 -518 2 9.3276 11.8473 7.39447 15.1337 1.48797 7.8591 -519 2 8.12011 12.397 7.99286 -24.7878 10.4099 9.23055 -520 1 1.26093 1.88381 3.01396 9.71768 11.5305 -0.318626 -521 2 0.781341 2.25664 2.27301 -4.68813 -2.91629 -4.97973 -522 2 1.78505 2.63319 3.35529 -3.04295 -14.2735 3.58948 -523 1 4.11799 15.1078 9.73252 4.576 2.76804 -1.92408 -524 2 4.09335 15.377 8.80945 -5.53143 0.588802 -2.3225 -525 2 5.02333 14.7824 9.83323 -1.70794 -2.53339 7.76874 -526 1 7.21252 2.18262 14.5895 -3.17269 -14.8219 8.52343 -527 2 7.02371 1.74902 13.748 4.05246 3.09826 3.19753 -528 2 7.71073 2.97164 14.4061 4.58862 11.2949 -7.92291 -529 1 18.5773 14.6793 2.1781 -14.8885 -13.9434 -3.10254 -530 2 0.806981 15.0773 2.13409 4.68638 9.16713 1.06255 -531 2 17.8879 15.3584 2.08187 6.00104 3.32119 3.09374 -532 1 9.95988 2.75708 12.9307 -3.19888 4.8993 -0.068744 -533 2 9.83509 2.14797 12.1955 3.80206 -8.82317 -3.94881 -534 2 9.20326 3.3528 12.8696 -1.08171 3.11286 5.06453 -535 1 2.85334 8.94069 13.0534 -9.07349 -10.7547 -1.24525 -536 2 3.30632 9.75091 12.8027 2.98523 12.1914 -0.768468 -537 2 3.53212 8.32042 13.3313 9.61222 -2.32206 4.81477 -538 1 3.22451 8.40753 3.67121 22.1548 25.1655 0.793749 -539 2 3.78763 9.07745 3.2153 -17.2399 -11.2925 0.757254 -540 2 3.40605 8.58793 4.60238 -4.67213 -6.04062 1.9181 -541 1 5.62069 7.18926 8.53747 6.69229 -2.05947 9.74796 -542 2 5.86853 6.28591 8.76536 -0.744086 -3.6627 -12.9201 -543 2 5.09246 7.43537 9.3012 -7.69944 9.66912 -1.05292 -544 1 14.8771 1.33506 1.99369 -4.37531 -14.3045 14.6387 -545 2 14.6174 2.14132 2.47402 3.99094 2.69357 -12.1219 -546 2 15.1274 1.48157 1.08098 3.94771 15.4277 -5.2716 -547 1 8.29964 15.2018 0.824762 -0.280237 2.12341 -18.5848 -548 2 9.0741 15.0554 1.38374 0.657448 -4.01578 8.69554 -549 2 7.56069 14.656 1.13255 5.04945 -5.16558 7.75703 -550 1 15.6052 1.34643 7.22407 3.75056 4.73875 0.699016 -551 2 15.0587 0.773182 6.67423 -5.35564 1.12746 0.995868 -552 2 15.1053 2.16848 7.37587 -1.8024 -6.33902 1.47434 -553 1 4.99443 13.0609 18.5093 -5.69789 -0.343563 -13.2097 -554 2 5.39232 13.2306 0.720212 5.08054 -1.92613 6.3414 -555 2 5.7137 13.1567 17.8693 -5.50653 4.49423 4.11534 -556 1 15.3782 8.49607 18.1492 -5.08872 -0.806473 3.30258 -557 2 15.7135 9.0139 17.4023 0.0404722 4.09908 2.1153 -558 2 15.1698 9.14329 0.203973 4.81283 -1.94937 -4.21801 -559 1 12.0917 3.05456 18.3485 5.25344 -19.9367 5.19329 -560 2 12.3328 2.56101 0.492796 -7.10973 11.5886 11.7441 -561 2 12.4167 2.41374 17.7115 -1.86526 8.77132 -18.5664 -562 1 13.1991 12.6728 5.17615 -0.124316 -0.0560055 4.18836 -563 2 13.6438 11.8331 5.03438 2.42254 -3.05364 -13.3032 -564 2 13.4089 12.8359 6.10375 -5.84435 4.2533 1.84347 -565 1 6.03469 7.1207 0.0631469 12.4635 -7.18562 -1.52206 -566 2 5.88549 8.01359 19.0305 -4.09863 7.65543 -4.79966 -567 2 5.21365 6.64029 0.190066 -5.29753 1.61074 5.21091 -568 1 17.6997 15.9613 14.987 30.7149 -12.4194 32.4504 -569 2 16.8862 16.4214 15.1458 -18.1669 6.52853 -13.961 -570 2 17.8877 15.7083 14.0822 -14.2113 6.66636 -19.3843 -571 1 13.1806 0.977208 16.5993 3.21446 -7.78263 -3.05852 -572 2 14.1069 0.725878 16.7441 -1.84519 3.55213 2.46319 -573 2 12.7536 0.148831 16.339 0.610986 0.436683 6.04854 -574 1 11.0624 14.5912 7.28204 -11.2181 -3.76258 -2.73638 -575 2 10.3867 13.9846 7.62705 2.11873 3.9908 3.08505 -576 2 11.9143 14.2091 7.50586 0.261112 -7.43153 0.664812 -577 1 17.506 8.58052 2.09005 -0.444247 -11.7988 -12.468 -578 2 16.6642 8.31502 2.4773 -2.50704 5.84538 6.9832 -579 2 17.563 7.99026 1.31874 6.86903 3.37396 8.78538 -580 1 12.3502 7.95652 1.98027 -3.36099 -5.49894 -2.13311 -581 2 11.9195 8.80992 1.98547 0.506131 9.65618 1.3531 -582 2 11.9377 7.50693 1.23044 6.6222 -7.49408 4.60604 -583 1 11.9327 14.6311 10.3511 -13.8226 21.3891 7.58711 -584 2 12.0851 13.8189 9.91206 10.3006 -23.5502 -10.4516 -585 2 11.0014 14.8158 10.1424 3.95037 3.15478 8.54077 -586 1 6.86541 7.01247 15.582 10.3214 -0.24422 -5.9518 -587 2 7.78025 7.06796 15.2658 -3.95377 -6.01896 -2.62563 -588 2 6.83046 7.729 16.2102 -7.67029 5.21932 8.6005 -589 1 8.00165 4.68416 13.4443 -21.8863 -22.7248 -23.0503 -590 2 7.36443 4.84116 12.7101 7.64348 -4.39085 15.7408 -591 2 8.44337 5.50298 13.5544 13.6077 24.8283 3.95349 -592 1 13.4082 12.1692 14.291 7.74384 0.583631 -6.74495 -593 2 13.3391 11.2097 14.1788 -8.03609 -0.555633 4.00216 -594 2 13.8852 12.4587 13.496 -2.17037 2.06617 1.19415 -595 1 14.784 9.43826 7.28323 -11.1269 12.8929 16.9671 -596 2 15.4951 10.0466 7.55684 1.33033 -10.8665 -8.82607 -597 2 14.017 9.71262 7.81429 7.01149 -4.68319 -9.50468 -598 1 12.6837 17.0142 3.10751 10.9269 -13.9095 9.51878 -599 2 12.9708 17.2813 3.99359 -6.48615 4.53386 -3.20168 -600 2 12.1282 17.7068 2.75827 -7.19321 10.5694 -1.73823 -601 1 1.13983 7.14905 17.429 -19.8537 -0.642492 -7.24746 -602 2 0.229092 6.89189 17.6928 9.24629 12.0374 -0.554306 -603 2 1.04788 7.63326 16.5858 1.73105 -6.23108 5.83737 -604 1 12.8283 5.10796 15.6891 -3.1105 -1.51238 -5.72518 -605 2 13.5351 4.46064 15.5231 -0.330328 2.49365 6.49287 -606 2 13.2544 5.98171 15.6287 1.13166 -7.6156 1.26811 -607 1 2.48175 3.38612 5.07416 -11.4746 -6.3359 16.597 -608 2 1.87059 3.13723 5.824 15.2627 10.0051 -19.3068 -609 2 3.07561 4.08306 5.41325 -9.83136 -1.83582 -2.79497 -610 1 8.32062 11.2204 13.4908 14.3326 -12.3724 2.23055 -611 2 8.41586 10.9603 14.3918 -15.5351 3.38632 26.9235 -612 2 9.1195 10.7822 13.1796 -2.73354 4.12568 -26.6086 -613 1 12.9112 1.40899 13.3219 3.38587 -22.7152 11.6955 -614 2 13.5257 1.21801 12.5994 -2.66679 10.6744 -3.40434 -615 2 12.4724 2.23119 13.1327 -1.22779 13.5514 -6.35015 -616 1 6.39925 13.6301 2.14388 13.7527 -0.778699 -6.56015 -617 2 5.84347 14.0897 2.78318 -1.88549 -3.79567 9.96763 -618 2 7.03431 13.0755 2.63977 -7.58465 4.89894 -0.0461429 -619 1 15.9327 6.56061 12.7538 -0.9836 2.19135 -10.6596 -620 2 16.5146 6.98287 12.103 -5.34808 0.40017 1.48081 -621 2 16.2873 6.8165 13.6112 3.99792 -3.90075 7.11277 -622 1 16.8306 0.705066 9.59578 -7.6122 -1.79623 -7.44488 -623 2 16.785 18.3903 9.75048 3.18156 2.06447 -0.865929 -624 2 16.3719 0.843651 8.74144 5.4764 0.262409 5.10626 -625 1 6.12658 11.6826 8.3633 -3.5227 -13.2845 -7.84739 -626 2 5.19255 11.5559 8.64231 15.2704 -3.4985 -2.63712 -627 2 6.45331 10.8168 8.01189 -8.18375 16.1965 9.35276 -628 1 2.85137 8.68091 0.385463 -5.58051 9.89965 12.0536 -629 2 2.19225 8.31695 18.4611 -2.16592 -25.8024 -20.6889 -630 2 2.2971 9.35613 0.77772 10.4924 10.4953 14.3564 -631 1 10.1291 10.4583 6.52809 -2.44089 1.08082 5.72444 -632 2 10.551 9.78353 7.0828 -0.111445 0.581803 -4.14441 -633 2 10.6952 10.5682 5.75546 0.540532 -2.90301 -3.90698 -634 1 6.75412 15.726 6.57209 -8.13971 -2.30487 -2.02419 -635 2 7.24364 15.9641 7.36655 2.15693 7.18823 -0.87292 -636 2 6.8879 16.4298 5.90744 8.86888 -7.67267 7.00242 -637 1 6.43944 13.0908 5.62507 5.5957 4.80241 6.78236 -638 2 6.68766 13.9873 5.91055 -1.86537 -6.12454 -2.89892 -639 2 6.02344 12.6885 6.39583 0.545895 -2.8305 -0.33431 -640 1 16.7919 12.5477 9.81186 8.33998 7.78307 -15.4118 -641 2 16.959 11.947 9.07064 -2.3739 -7.40637 3.16023 -642 2 17.0566 13.4004 9.43565 -5.48117 -2.43007 10.0621 -643 1 6.08508 2.94496 2.79534 5.32525 -4.78467 20.7365 -644 2 6.22401 3.88181 2.60268 1.06349 -0.160394 -8.38338 -645 2 5.80007 2.47136 2.00522 -4.08992 3.93243 -8.80646 -646 1 10.8869 3.24711 3.28239 -4.40001 1.54122 -3.81905 -647 2 10.3919 4.04182 3.50512 -0.182415 -1.04618 4.274 -648 2 10.507 2.97693 2.43998 1.37333 -6.80979 -0.861155 -ITEM: TIMESTEP -40 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.77679 7.00681 17.9176 19.5781 -11.4355 -6.13067 -2 2 7.88289 7.04978 18.2154 -24.3238 4.20085 7.9494 -3 2 8.82569 6.20257 17.3924 1.80136 1.41546 -3.93969 -4 1 18.6608 8.28849 6.81179 -5.26854 6.47195 -37.0065 -5 2 0.259818 8.10211 5.87223 -9.20216 6.37217 14.1473 -6 2 0.533966 7.65898 7.28863 11.4703 -14.4857 21.9358 -7 1 8.44459 18.6539 6.84319 -15.0888 3.44445 3.75329 -8 2 9.31627 0.207433 6.52222 15.1831 4.47029 -4.67038 -9 2 7.87035 0.688968 6.45696 3.7806 -3.44044 1.26969 -10 1 6.57294 1.78151 11.6706 -30.0599 9.45416 18.0529 -11 2 5.79693 2.24632 12.0928 24.7239 -13.8096 -10.3139 -12 2 6.23894 0.879353 11.5248 3.88204 4.12095 -2.29502 -13 1 7.0611 5.68864 2.39703 8.93877 -14.6422 -9.86735 -14 2 6.49127 6.20844 2.93802 -15.3109 10.2002 23.1803 -15 2 6.88849 6.05122 1.53455 1.63853 6.11013 -15.8751 -16 1 16.2018 10.2111 16.0976 42.0151 -2.30245 8.02011 -17 2 17.1767 10.3828 16.1846 -31.1897 -9.90141 -8.38467 -18 2 15.8087 11.0308 16.3852 -12.3763 9.98735 1.02793 -19 1 10.6387 14.9527 2.33657 9.03987 18.5511 -2.17595 -20 2 10.545 14.5243 3.1949 1.96881 -4.62445 -0.461144 -21 2 11.2262 15.72 2.53493 -10.4825 -13.512 -5.5858 -22 1 17.1607 8.25027 10.5569 -10.4361 3.90862 15.3578 -23 2 16.8456 8.92829 11.1924 -0.168965 -8.85021 -9.39988 -24 2 17.9277 8.63713 10.1294 7.74511 3.00226 -1.55375 -25 1 14.7566 15.8542 16.4215 -9.50848 16.8449 -9.38304 -26 2 13.8265 16.1715 16.4278 14.8795 -5.02546 -3.6071 -27 2 14.9162 15.569 17.3232 -2.48975 -11.4773 7.52297 -28 1 12.1331 13.4103 0.48985 -10.556 -4.43922 -13.5861 -29 2 11.9475 13.3795 18.1761 8.0664 -0.863413 7.07636 -30 2 11.3865 13.8946 0.862316 6.65844 3.98247 10.4433 -31 1 9.29843 5.44761 4.00486 3.37284 8.34248 -28.0116 -32 2 8.80378 5.24143 4.78809 -8.97197 -9.15203 12.3932 -33 2 8.61542 5.51114 3.30134 8.62356 -3.76178 8.99247 -34 1 1.79678 4.17189 11.6321 9.86643 -30.5991 16.8051 -35 2 1.62878 5.09135 11.8205 -3.04918 18.6361 6.49963 -36 2 2.25792 3.77365 12.4221 -11.5809 11.2089 -24.12 -37 1 2.02425 6.80455 8.32417 0.209126 8.78432 0.0974623 -38 2 2.41895 7.33028 9.04952 -2.4595 -11.9319 -6.9206 -39 2 1.91003 5.89259 8.64365 4.06316 7.1017 -1.03524 -40 1 5.41039 4.42866 7.97545 15.1976 -3.31539 14.1613 -41 2 5.46063 3.46886 7.81834 -3.32316 3.28084 -1.43066 -42 2 4.8072 4.83488 7.36206 -13.6118 -1.04066 -17.9483 -43 1 3.27942 2.94296 17.507 14.649 -12.38 -13.2068 -44 2 4.01307 3.22765 16.9192 -12.2988 4.29907 8.19647 -45 2 2.92414 3.72569 17.9407 -4.7152 6.06254 1.98711 -46 1 7.44402 5.32718 6.09908 -2.23439 -3.56175 -18.7368 -47 2 8.08992 5.98284 6.3762 -3.15187 6.11466 20.9447 -48 2 6.88688 5.06352 6.84221 3.51936 -1.39652 7.32666 -49 1 9.78623 6.99393 11.9838 -8.59529 -1.09594 -12.3674 -50 2 10.3445 6.45759 11.4052 1.55365 1.23763 7.43723 -51 2 9.00985 7.18223 11.4209 7.62587 2.79809 7.26056 -52 1 14.0725 3.61727 8.08367 12.8617 -8.18347 36.7285 -53 2 14.0228 4.31343 7.45005 -3.4794 19.1063 -13.5046 -54 2 14.4179 4.02628 8.91908 -9.29791 -10.4076 -21.8094 -55 1 4.59231 17.2384 3.97449 0.493238 3.33808 0.649061 -56 2 5.51414 17.4776 4.03994 12.0557 0.622386 5.90157 -57 2 4.23063 17.8039 3.28947 -7.41249 -4.06804 -9.31956 -58 1 16.4721 16.5989 10.1846 -15.657 14.3962 29.6607 -59 2 15.672 16.8273 10.736 23.5631 -12.0212 -18.4682 -60 2 16.1719 15.9965 9.50314 -9.75188 -3.46964 -7.56259 -61 1 1.98052 4.85246 0.373619 -1.44601 4.98585 -7.77412 -62 2 2.7262 5.17853 0.894803 -2.15831 4.7879 6.78517 -63 2 1.59165 5.65237 -0.0264377 4.8265 -6.05414 -1.09652 -64 1 11.6431 13.3034 16.3099 -7.83069 14.4437 11.7005 -65 2 11.0472 12.5464 16.386 4.77345 -10.1552 -4.34879 -66 2 12.2516 13.1635 15.5747 -3.53477 -7.02177 -5.05796 -67 1 10.1531 11.0326 16.9094 -23.9188 11.6521 -2.01913 -68 2 10.5087 10.1543 16.8125 9.70699 -14.9542 1.17008 -69 2 9.18648 10.9213 16.8155 11.1855 0.742098 0.22461 -70 1 11.7413 17.4552 13.4621 -1.23374 28.315 3.5075 -71 2 12.4767 17.2116 12.8888 0.8966 -9.51431 -5.30227 -72 2 11.7922 18.439 13.4864 2.17346 -17.034 -0.823798 -73 1 6.40572 9.32656 12.214 8.55802 19.8904 20.5686 -74 2 6.90308 8.91303 11.5283 8.82473 -10.1612 -21.9185 -75 2 7.05175 9.94906 12.6124 -18.2049 -7.77814 -0.199089 -76 1 16.2334 12.8098 2.68826 14.0272 -12.5996 -1.63763 -77 2 17.097 13.226 2.50419 -12.4159 2.28924 0.929092 -78 2 15.5495 13.4898 2.7216 0.770652 8.50493 2.13384 -79 1 0.665645 12.593 5.91595 32.2246 4.40393 3.59492 -80 2 0.90587 12.5095 4.99041 5.40697 -3.98614 -5.66175 -81 2 18.3758 12.6087 5.91046 -34.4951 5.63016 -3.48792 -82 1 5.23151 16.431 18.4431 -16.7943 8.81872 -4.95242 -83 2 5.79594 15.7593 18.0508 10.3373 -8.32481 3.89376 -84 2 5.47944 16.6222 0.707356 8.36178 -5.19521 1.40492 -85 1 0.571414 7.67431 4.12619 2.94709 1.59491 -2.60127 -86 2 18.6158 8.07004 3.46977 2.09916 -2.88444 -0.00351913 -87 2 1.46322 7.94524 3.84829 -2.55586 0.342718 0.201417 -88 1 3.11705 8.93424 6.4998 54.1901 -7.8337 2.25484 -89 2 3.7667 8.5317 7.12157 -13.167 10.549 -15.4875 -90 2 2.28764 8.76575 6.88741 -36.769 -1.96533 12.6863 -91 1 7.28047 10.3297 16.2671 12.2744 -1.5589 -10.8048 -92 2 6.65751 10.5384 15.5688 -5.93087 0.719661 3.96859 -93 2 6.78418 10.1979 17.0822 -4.65586 3.14184 2.44827 -94 1 11.1311 1.01006 5.00872 -4.59838 3.25637 13.1063 -95 2 11.104 1.87564 4.56859 3.00456 -5.57579 -4.19999 -96 2 10.7195 0.375584 4.41788 -1.87117 -0.379426 -13.1931 -97 1 4.37947 2.77237 13.219 1.2209 -0.528365 -1.66794 -98 2 4.72737 3.08878 14.0495 2.85744 14.0767 5.60955 -99 2 4.20383 1.85536 13.4394 -3.83295 -12.6961 -6.71285 -100 1 8.38383 10.1509 1.80871 -12.6182 20.2791 -9.41543 -101 2 8.178 10.838 2.47049 7.2019 -6.44506 -5.42193 -102 2 8.73482 9.42727 2.30684 9.9898 -17.6863 11.9989 -103 1 10.4319 1.72481 15.5562 12.4011 -4.85254 7.43664 -104 2 11.3895 1.56158 15.4091 -17.4954 3.73262 -0.131687 -105 2 10.062 2.13812 14.7716 6.37582 -0.463351 -11.2945 -106 1 2.70803 12.8564 7.7877 0.947466 12.6679 0.63847 -107 2 3.18684 13.6562 7.51328 0.350127 -6.04869 0.642024 -108 2 1.99719 12.778 7.13709 0.576803 -6.26493 0.417134 -109 1 3.70343 11.6943 5.19413 20.2082 20.004 0.0632986 -110 2 3.58824 10.8286 5.55511 -6.2763 -16.1433 9.0068 -111 2 3.08304 11.8089 4.48497 -14.3756 -1.22762 -7.56914 -112 1 6.79775 14.44 16.9261 12.4025 3.68508 -3.36544 -113 2 7.76361 14.3574 16.912 -9.58328 3.53086 0.838276 -114 2 6.54478 14.7426 16.0399 -3.94857 -4.38541 1.40645 -115 1 14.2011 14.5459 3.3522 -3.08566 -2.84615 -1.00806 -116 2 13.6596 15.3308 3.14384 3.83224 -9.07839 4.89455 -117 2 13.7292 13.9763 3.99269 1.14293 11.3016 -6.48612 -118 1 8.39096 18.1361 16.0337 -32.316 13.1552 1.22555 -119 2 8.83502 17.3455 16.3332 22.4875 -6.85104 -0.859562 -120 2 8.9267 0.219511 15.6905 18.196 -4.39201 7.01778 -121 1 4.72714 1.63535 4.92703 -26.6842 -20.3158 26.1173 -122 2 3.8064 1.92851 4.99525 4.72714 3.40068 -1.69015 -123 2 5.07003 2.08002 4.18139 17.9323 21.4409 -28.6349 -124 1 14.9964 12.7123 16.4352 -4.22015 -14.1687 -30.4934 -125 2 14.5029 13.21 17.0522 -6.30453 18.4993 32.9687 -126 2 14.3164 12.5754 15.7407 23.1427 -3.84454 1.0347 -127 1 15.7385 18.4508 16.8675 -13.9243 -22.2803 -23.7862 -128 2 16.4074 18.4637 17.529 20.9098 4.79862 21.1737 -129 2 15.5806 17.4953 16.7298 -7.09236 11.271 1.12369 -130 1 1.21817 1.19055 16.5653 11.7565 -7.97186 -17.2906 -131 2 1.96844 1.77109 16.7379 1.96571 4.11248 6.40071 -132 2 0.658106 1.26508 17.3256 -9.62795 7.29392 16.1709 -133 1 18.134 4.50826 15.9251 -3.15057 6.2034 16.9599 -134 2 18.3539 4.06683 15.1192 3.29697 -9.24478 -15.9855 -135 2 0.215105 4.3469 16.5346 0.451532 1.5183 -0.00159427 -136 1 12.2559 16.9635 16.13 9.81693 16.417 -30.969 -137 2 11.5335 16.7255 16.6761 -27.6315 -15.1383 17.2649 -138 2 11.8852 17.008 15.2138 11.4543 -2.176 15.2032 -139 1 16.0072 2.53826 18.0715 2.86853 -7.51147 -8.26075 -140 2 15.4847 3.23875 18.4474 -1.55266 16.6686 8.62869 -141 2 15.8031 2.59593 17.1292 0.710765 -2.58084 -2.04371 -142 1 6.70782 13.8427 10.2201 -0.679857 -3.70625 -19.7607 -143 2 6.50134 13.5235 11.1067 -0.321862 -5.5215 0.0793921 -144 2 6.59662 13.1168 9.5703 -2.40279 4.60459 14.5526 -145 1 10.136 18.3381 2.74267 -18.0567 -22.0341 20.6824 -146 2 10.1719 0.451126 2.17508 1.85432 15.9621 -15.8725 -147 2 9.21984 17.9907 2.65838 20.6262 7.0183 -5.07627 -148 1 3.02443 17.7208 6.1026 17.1013 10.0229 -4.66436 -149 2 2.15568 17.711 5.71196 -13.0363 -3.14036 -7.80794 -150 2 3.59824 17.9918 5.35649 -4.18715 -9.59785 14.6662 -151 1 12.576 16.8948 8.01086 19.6337 5.92584 -6.52436 -152 2 11.8143 16.3513 7.79321 -8.3204 -4.9503 8.18666 -153 2 12.4158 17.4227 8.81259 -8.93553 -1.00079 -7.85288 -154 1 14.8883 15.2954 8.22088 18.3997 -23.9506 8.44323 -155 2 14.185 15.9366 8.136 -10.7922 9.32905 -8.87486 -156 2 15.3949 15.2296 7.38647 -11.857 13.9652 6.76292 -157 1 17.682 18.2494 0.348905 -7.91474 13.422 2.87656 -158 2 18.5411 17.7865 0.321045 -1.05993 10.3639 -2.93184 -159 2 17.7527 0.554981 0.612143 9.7328 -21.6142 -4.56589 -160 1 0.864553 10.4271 1.36107 38.8853 37.5027 -14.379 -161 2 0.108953 9.99831 1.68821 -41.9718 -23.1906 9.82059 -162 2 0.582253 11.2112 0.83245 0.481516 -18.0373 9.72219 -163 1 1.69239 12.2275 3.35367 -4.8948 -13.153 3.57872 -164 2 1.37753 11.4769 2.79371 7.82838 19.3971 -0.83705 -165 2 1.72119 13.0511 2.84994 -1.71551 -5.72989 -9.02345 -166 1 0.593488 17.2339 4.88925 5.54216 -9.27995 13.1842 -167 2 18.6577 17.9974 4.73698 -0.720643 -6.26101 15.0882 -168 2 0.46443 16.7935 5.76992 -5.72363 16.5902 -22.8723 -169 1 1.11371 0.949119 9.43078 -14.7072 -12.8067 -15.4602 -170 2 1.29442 0.455313 10.245 -0.545661 8.99323 2.98013 -171 2 0.250893 0.599212 9.12975 16.3522 9.05079 5.79158 -172 1 16.7438 2.34594 13.2927 -5.57812 -16.9062 26.8121 -173 2 16.8801 2.6271 12.4058 4.66444 4.54161 -27.0891 -174 2 16.4868 1.39796 13.2842 6.06262 14.3342 0.102967 -175 1 2.62374 15.8311 12.1325 -18.0747 14.04 -25.4855 -176 2 3.15014 15.3809 12.7666 13.9506 -11.3972 18.0386 -177 2 3.07511 15.7224 11.2774 1.07994 -2.68321 4.96368 -178 1 16.4243 15.6576 6.03755 15.9104 -4.34147 -2.36376 -179 2 17.3476 15.7161 6.33483 -8.235 -6.85341 4.18965 -180 2 16.3427 16.413 5.44101 -7.92512 0.157724 -1.18513 -181 1 5.79129 5.09168 11.8004 -4.72983 -0.0241771 3.34223 -182 2 5.24592 5.67928 12.3598 8.87085 -1.40185 -4.45321 -183 2 5.33436 4.24005 11.794 -1.89173 5.24027 0.81451 -184 1 15.1611 4.86757 0.757741 -10.8083 7.02962 -6.60621 -185 2 15.185 4.56786 1.66832 -2.59424 -2.50065 9.27943 -186 2 14.3347 5.37902 0.687967 11.9305 -6.73266 -3.44958 -187 1 16.3215 16.3801 2.08305 3.66808 -22.0917 28.3334 -188 2 16.2883 16.7145 3.0131 -8.2177 -1.24054 -23.9705 -189 2 16.5228 17.1161 1.52724 6.03518 21.1991 -10.8898 -190 1 0.258418 4.84833 3.80491 9.83943 -33.1452 17.0376 -191 2 0.435143 5.7654 3.92096 2.60191 31.4745 -0.643169 -192 2 0.932226 4.39489 4.35318 -12.3014 6.6918 -13.6862 -193 1 2.96829 15.0617 15.1396 -6.44278 -4.84309 -5.22724 -194 2 2.79942 14.7982 16.0602 -0.108783 -2.99279 -5.19286 -195 2 2.41643 15.8476 15.0194 7.7594 2.37019 3.88633 -196 1 1.13965 14.6405 9.53256 -35.9747 -40.3241 22.6064 -197 2 2.06314 14.7027 9.49112 43.1319 12.9068 -8.07313 -198 2 1.0594 13.7772 10.0119 -9.44904 20.5678 -15.2205 -199 1 13.5675 16.5961 11.5382 5.93785 -23.7105 -2.52771 -200 2 13.3768 17.2545 10.8786 -7.41053 16.3631 -3.48345 -201 2 13.1856 15.7884 11.1314 1.00946 8.65797 10.7521 -202 1 4.66618 1.4643 0.77663 11.7421 5.19522 -12.5382 -203 2 4.19094 2.00712 0.127209 -4.75679 -3.07286 5.52347 -204 2 4.08138 0.751582 1.04859 -6.60629 -1.36494 5.43578 -205 1 1.44472 18.5589 11.8552 5.89014 -29.5111 2.70443 -206 2 1.28184 0.411827 12.6654 0.0657759 4.1157 4.72514 -207 2 1.66959 17.6355 12.1243 -0.811151 21.0135 -2.36357 -208 1 11.5239 10.1243 4.0099 -6.2394 6.26334 5.03821 -209 2 11.225 10.535 3.18075 6.07738 -4.97061 3.39644 -210 2 12.4891 10.1836 4.01184 1.61922 -2.52467 0.807021 -211 1 8.27885 12.1614 3.71144 8.13123 -6.41358 -26.5436 -212 2 9.10665 12.5897 3.97429 -2.42085 2.52867 6.94663 -213 2 7.68553 12.1691 4.45091 -10.6399 7.25218 24.1014 -214 1 14.4389 4.03262 3.28382 -1.54769 2.04788 0.687462 -215 2 14.9998 3.98927 4.07922 -0.140352 3.9435 -3.93632 -216 2 13.6855 4.60992 3.49399 3.24138 -5.01437 4.30138 -217 1 5.6049 1.66195 7.51556 2.43321 19.3851 -35.7094 -218 2 4.99817 1.05358 7.93111 -11.2062 -8.09843 6.71806 -219 2 5.29033 1.73413 6.56196 15.7086 -7.98236 30.9511 -220 1 17.8679 1.11465 4.8662 -8.84521 -11.3875 -0.414623 -221 2 18.5938 1.34898 4.28573 7.92092 9.45731 -1.66923 -222 2 17.9348 1.63294 5.67672 2.41874 4.31495 -1.38437 -223 1 6.82183 9.41821 4.49596 0.331068 -0.81956 4.69879 -224 2 6.92763 9.68813 5.42975 0.55668 -5.9518 -10.6641 -225 2 7.69076 9.13696 4.17138 2.49623 1.53594 7.84385 -226 1 2.6692 14.9191 1.96889 -13.7427 -15.0981 33.3863 -227 2 3.22272 14.7135 2.75628 -3.53882 5.4164 -17.9931 -228 2 3.23582 15.271 1.30455 16.0902 7.51076 -16.3339 -229 1 17.3236 12.914 13.1856 6.20451 10.459 -3.7314 -230 2 16.5162 13.3803 13.3896 -16.2035 -4.78456 4.03007 -231 2 17.8657 13.6659 12.9192 5.22743 -7.26423 -1.93052 -232 1 14.957 10.5619 1.40158 33.4378 15.8576 14.4167 -233 2 15.5687 11.2535 1.77718 -16.3935 -17.8486 -10.6273 -234 2 14.0947 10.9454 1.47451 -15.7071 3.57407 -1.68856 -235 1 5.70225 6.80052 4.56184 6.57688 14.9147 -7.26545 -236 2 6.13296 7.68472 4.64206 -12.0226 -12.483 -2.28626 -237 2 6.28869 6.17268 5.00191 2.5554 2.13057 5.94298 -238 1 8.01258 8.29623 10.2593 -8.54796 -9.21297 9.02749 -239 2 8.56841 9.06789 10.0886 3.62647 -1.62136 -15.6888 -240 2 7.62542 7.94814 9.4343 7.03713 6.69092 4.95874 -241 1 13.441 18.4149 5.75957 4.19405 2.302 -13.2138 -242 2 12.6243 0.255994 5.52243 8.89948 -2.22339 5.88848 -243 2 13.1991 17.7887 6.44621 -5.69407 0.108635 9.70575 -244 1 0.157493 2.61527 0.174457 -9.01339 -22.8294 -0.321401 -245 2 17.938 2.88173 18.4446 6.58659 5.28303 7.29983 -246 2 0.732894 3.35773 0.380844 -2.17088 12.8237 -3.11298 -247 1 12.7457 11.0391 9.7485 36.4778 -29.6492 25.4167 -248 2 11.881 10.9734 9.40839 -39.1103 -1.43989 -11.0388 -249 2 12.9187 10.1217 10.0968 -0.290925 20.2268 -9.99681 -250 1 0.740308 12.1745 11.0603 -22.9837 8.27774 -1.01284 -251 2 18.4139 12.2368 11.1424 7.83285 -3.43363 -6.48653 -252 2 1.04445 12.5328 11.8929 13.1768 -0.7817 9.81141 -253 1 5.09631 7.29496 13.4329 -5.02176 -6.40528 2.12919 -254 2 5.65923 7.87015 12.9013 0.281799 7.42737 5.37855 -255 2 5.54275 7.21467 14.2893 3.22018 -2.41867 -5.38403 -256 1 1.21307 6.88521 11.8471 45.2055 23.2855 19.4361 -257 2 0.504281 7.33909 11.418 -17.6401 7.5893 -9.966 -258 2 1.85566 7.62216 12.1147 -28.9146 -29.9066 -6.84092 -259 1 15.4951 9.58282 12.318 3.7565 -9.08444 -2.54037 -260 2 14.9885 10.3731 12.1762 -1.60608 19.4691 -5.65324 -261 2 15.197 9.26603 13.1641 1.66558 -4.92983 10.8479 -262 1 16.5876 12.7654 5.4778 8.29992 -4.99789 29.9812 -263 2 16.3841 13.7077 5.58453 -1.61151 1.51391 -8.42869 -264 2 16.4534 12.5134 4.57091 -6.79319 5.2662 -20.9737 -265 1 6.24519 9.93185 0.0511849 19.8307 -8.34124 26.5163 -266 2 5.62326 10.391 0.623031 -8.96333 4.37615 -1.09153 -267 2 7.04636 9.86115 0.632167 -14.2701 4.68407 -14.2447 -268 1 12.3094 6.10151 4.07154 29.4526 9.60181 -18.9544 -269 2 12.3581 6.67925 3.27122 -7.72489 -2.14158 19.4346 -270 2 11.4533 5.70734 4.07903 -24.5921 -5.49884 -2.8127 -271 1 0.238725 12.7856 0.183979 8.51406 3.08383 0.253195 -272 2 0.144933 13.4932 0.833619 -6.86037 1.22763 2.8825 -273 2 18.4214 13.096 18.0418 -3.66036 2.31192 -5.9902 -274 1 3.70956 18.598 8.57987 -8.91795 8.796 11.4474 -275 2 3.55449 18.0356 7.80833 -3.96611 6.10323 -0.149317 -276 2 2.8446 0.378518 8.78385 11.2365 -8.2841 -4.38951 -277 1 7.48876 17.3305 4.49636 -9.17434 -25.7083 -0.449464 -278 2 7.67261 18.2518 4.49855 7.01126 32.4538 5.60223 -279 2 7.56532 17.0943 3.57389 -1.71949 -1.63571 -7.00131 -280 1 9.24209 17.1007 12.2607 -0.0867103 -4.31389 -13.5747 -281 2 9.30622 16.4126 11.5797 -4.40084 -0.983353 3.37399 -282 2 10.1228 17.1279 12.6444 4.44927 1.46684 7.86514 -283 1 13.3362 12.9421 7.98122 6.55916 41.1429 -16.6734 -284 2 13.3796 12.1892 8.55526 4.57885 -11.5398 14.8452 -285 2 13.9495 13.647 8.31623 -8.21726 -16.9651 -6.13203 -286 1 14.9343 2.98184 15.3399 -18.8859 -3.08059 15.3623 -287 2 14.3306 2.22694 15.2091 8.05839 6.56319 -1.64083 -288 2 15.5611 2.99492 14.6188 6.00199 -3.60128 -9.94013 -289 1 9.8611 15.5568 16.9864 -5.18568 1.15062 7.50023 -290 2 10.3014 14.7282 16.7357 2.8278 3.85059 0.776615 -291 2 9.42894 15.4199 17.8518 3.24739 -0.30663 -9.25648 -292 1 11.3089 8.34774 16.5637 -8.99518 -4.25182 3.40254 -293 2 10.6351 7.93491 15.9913 5.93093 -1.15278 9.90769 -294 2 11.3777 7.78039 17.3602 -0.876032 6.75541 -11.8921 -295 1 3.86263 18.1743 16.7605 8.31608 -24.0238 3.67333 -296 2 4.34809 17.526 17.3016 -5.03788 -1.4921 -11.4176 -297 2 3.91859 0.291346 17.3034 -3.84782 28.4328 8.21839 -298 1 2.18675 4.1526 8.92206 -24.1698 7.19476 -17.4672 -299 2 3.08777 4.02084 8.66345 19.2563 -3.88604 2.84364 -300 2 2.11989 4.14607 9.87269 6.11123 -7.11558 17.6044 -301 1 9.878 10.3743 9.69372 5.53967 -18.4491 14.0185 -302 2 9.43572 11.1423 9.3425 -1.35277 14.796 -0.820696 -303 2 10.0526 10.4842 10.6451 0.294207 2.81912 -6.3598 -304 1 9.67606 0.861397 10.8616 12.1631 -0.119776 7.34561 -305 2 9.24662 0.0503119 11.2005 -2.60905 7.79605 -9.27605 -306 2 9.17358 1.27941 10.1433 -7.66403 -7.87567 2.43043 -307 1 9.19351 15.1133 10.2188 11.11 2.94282 0.236533 -308 2 8.72034 15.7288 9.64731 -2.95318 7.0206 -0.021652 -309 2 8.61234 14.3559 10.3013 -9.273 -0.749783 0.810803 -310 1 0.983709 9.49699 10.2982 -74.1988 19.4185 4.2569 -311 2 0.893433 10.4494 10.5162 13.7438 -13.7231 -2.84852 -312 2 1.86549 9.26486 10.2468 58.3196 -6.52918 -3.90093 -313 1 16.9084 4.83943 8.1598 4.06942 21.6595 -28.8412 -314 2 16.3724 5.61591 8.36865 -1.41178 -4.09344 3.51719 -315 2 16.8393 4.26054 8.89216 -0.699807 -17.3102 23.1105 -316 1 14.7125 14.7098 0.257213 21.3866 7.73012 -2.74727 -317 2 15.2455 15.0698 0.987096 -5.24332 1.02996 -2.3964 -318 2 13.934 14.3364 0.654485 -15.8904 -6.61515 6.72623 -319 1 3.61962 11.0361 9.55343 7.54802 -1.42323 12.4812 -320 2 3.62776 11.3571 10.4773 -0.544226 1.54555 -6.56144 -321 2 3.18313 11.7186 9.01674 -3.18494 -0.813089 -1.4949 -322 1 11.1481 10.7794 1.3867 -18.0125 -13.9714 2.13506 -323 2 11.5419 11.6189 1.17487 5.50703 16.2749 -10.1623 -324 2 10.2377 10.7815 1.02242 13.9743 0.382042 6.15217 -325 1 13.1644 7.14571 12.7934 28.1674 11.2254 -0.0108115 -326 2 14.1505 7.05998 12.7803 -16.3048 -3.53009 2.57838 -327 2 12.835 6.25234 12.9024 -6.40061 -9.363 -1.95696 -328 1 9.62034 1.87073 0.979069 -6.9897 -0.645983 -14.1021 -329 2 8.86926 1.41829 0.528843 9.90899 13.9476 5.87182 -330 2 10.1257 2.37739 0.312436 -3.40486 -11.198 4.68953 -331 1 10.6367 13.5403 4.62088 -14.2461 -11.7796 -9.34504 -332 2 11.3649 12.9086 4.64313 9.4379 4.41524 3.81629 -333 2 10.614 13.9519 5.48444 4.98914 7.07 10.6976 -334 1 14.3951 1.77229 10.9373 11.882 -13.8992 0.14286 -335 2 15.2529 1.46692 10.5904 -8.80209 -5.09491 0.192719 -336 2 14.4998 2.72321 10.9422 -3.89457 8.74507 -1.42899 -337 1 14.6035 12.2778 11.6732 8.28457 -2.47972 34.5189 -338 2 15.3822 12.4706 11.1386 -1.8445 -1.29245 -12.2333 -339 2 13.8238 12.1274 11.1597 -9.6117 -2.29221 -24.4043 -340 1 8.21682 5.05944 9.82725 33.2235 -12.7421 -22.1109 -341 2 7.50249 5.31613 10.3805 -26.8995 -2.6371 14.604 -342 2 8.16278 4.09579 9.61432 -6.39419 19.305 4.57693 -343 1 1.57178 16.8746 18.3696 -12.5949 -28.7752 19.8992 -344 2 1.95856 17.2997 17.6256 12.4489 12.7929 -23.944 -345 2 1.61191 15.9133 18.1414 3.74732 18.7705 7.54273 -346 1 1.50483 17.2622 15.3369 -31.2805 -0.211241 0.372367 -347 2 1.56428 18.1715 15.7008 -8.02099 -13.4799 -3.86937 -348 2 0.550545 16.944 15.3287 29.8388 16.9503 2.40621 -349 1 3.67189 5.70682 6.10259 2.52977 5.35962 -6.45813 -350 2 3.10512 6.24939 6.65687 -5.8484 1.84291 7.09291 -351 2 4.11645 6.33532 5.504 1.86189 -8.61654 4.18176 -352 1 12.4205 9.46682 14.1922 0.00765934 6.29699 5.01976 -353 2 12.7713 8.66673 13.7826 1.27338 -5.49384 -0.333278 -354 2 12.2037 9.20626 15.0998 2.51081 -2.42178 -0.168732 -355 1 4.04257 15.2822 6.8914 -27.6779 4.92775 8.06061 -356 2 3.56316 16.0906 6.63798 2.42102 -8.57509 -1.16647 -357 2 4.95231 15.5118 6.77617 25.3206 1.78005 -4.31003 -358 1 0.630616 8.59357 14.9621 0.0534875 13.3347 6.63524 -359 2 0.475879 9.54739 15.0951 0.802494 -5.58418 -0.636111 -360 2 1.32488 8.5708 14.2996 4.58301 -1.27906 -6.75903 -361 1 12.9988 8.28033 10.3217 -21.3611 19.4324 1.5895 -362 2 13.6573 7.74741 9.88515 12.8548 -10.016 -2.83384 -363 2 12.9714 7.9897 11.246 0.968107 -4.04745 -5.09921 -364 1 15.3184 7.7322 3.54707 4.18654 -9.90345 10.9868 -365 2 14.6375 7.17364 3.22195 -21.9236 0.488691 -25.4272 -366 2 15.542 7.2045 4.31452 16.9904 15.0521 14.7627 -367 1 17.298 6.68564 0.0426033 13.9193 -14.0885 -0.920406 -368 2 16.8642 5.82471 0.139777 0.0396094 5.05794 2.76644 -369 2 16.6003 7.28204 18.4358 -17.9105 11.3609 -4.38582 -370 1 8.85442 6.93876 7.83202 25.5204 20.9839 -12.9835 -371 2 9.78415 7.28149 7.87459 -21.3181 -5.86923 -3.23496 -372 2 8.81067 6.25344 8.49096 -5.61401 -13.4392 14.4413 -373 1 12.3763 0.596552 1.22002 -1.17453 2.99561 6.82033 -374 2 13.3385 0.528874 1.30915 -5.26207 -0.953155 0.827968 -375 2 12.0852 0.273415 0.369127 5.54968 -2.26078 -4.64309 -376 1 5.63283 15.1348 14.5573 -11.4131 -7.08845 -3.56826 -377 2 4.66833 15.2302 14.6984 9.61439 -4.03287 3.27369 -378 2 5.92452 15.9751 14.1944 7.77409 8.39082 -1.96781 -379 1 3.86657 6.44559 1.75085 5.80409 -14.6499 1.98717 -380 2 3.55249 7.31671 1.4889 -5.45171 9.45984 0.647045 -381 2 4.14269 6.4981 2.68117 -5.39897 6.08822 -6.8935 -382 1 3.91507 11.6157 12.3486 -13.4135 -1.42429 5.74998 -383 2 4.7693 12.0145 12.538 6.44699 -0.479912 -1.2837 -384 2 3.27735 12.1325 12.8813 7.77399 -7.15276 -11.5357 -385 1 5.36262 3.86651 15.8768 12.1389 -59.3419 -3.52329 -386 2 6.1064 3.19888 15.7551 -26.8485 22.8054 1.66706 -387 2 5.75212 4.71249 15.8089 15.627 34.646 -1.2618 -388 1 14.3819 10.2457 4.44716 -17.5064 5.46907 41.0935 -389 2 14.5449 9.71992 5.26671 -1.94493 10.8322 -14.5796 -390 2 14.8723 9.82528 3.76702 14.2142 -16.5996 -23.0963 -391 1 7.82031 17.402 9.18196 15.4978 -20.6961 5.52716 -392 2 6.95708 17.6159 9.5372 -6.73409 6.75657 -1.79958 -393 2 8.0438 17.9374 8.41052 -8.48575 5.6988 -1.01071 -394 1 4.52697 14.5011 3.99561 -1.64824 1.80571 -15.4173 -395 2 4.43911 15.4257 4.28139 2.0309 -4.99506 3.13673 -396 2 4.3827 13.9072 4.73582 -0.0495062 -0.930109 11.2178 -397 1 14.2192 7.41869 15.785 -17.5888 -3.59777 -10.979 -398 2 15.1626 7.35697 15.6947 20.631 -1.7403 -3.62609 -399 2 14.073 7.80524 16.6426 0.667235 5.42077 11.7037 -400 1 2.9565 18.2605 1.91108 1.19197 -18.909 -26.3864 -401 2 2.43337 17.7432 1.2423 11.354 8.34367 16.4878 -402 2 2.37308 0.276014 2.2689 -15.3488 13.3111 9.03739 -403 1 8.00359 1.60253 4.55907 -38.5212 -7.91491 7.83452 -404 2 7.38229 2.10405 3.99193 12.1921 -3.74558 1.60605 -405 2 8.88232 1.74243 4.26439 24.0023 10.0694 -13.3902 -406 1 2.4736 14.1336 17.6839 19.5549 7.85258 6.07398 -407 2 1.90347 13.5339 18.1719 -6.00167 -6.95039 -0.586477 -408 2 3.38553 13.9045 17.9683 -9.72011 -2.72883 -0.373401 -409 1 0.820064 1.73894 13.8888 -18.5285 5.33114 2.4032 -410 2 0.803771 1.49328 14.8397 -2.66487 6.43341 -16.8821 -411 2 18.5531 2.02517 13.6233 21.0072 -9.49287 13.5993 -412 1 4.44957 0.0409644 13.9204 -25.6038 8.03756 8.31677 -413 2 5.34611 18.3721 13.8825 17.1601 -8.5878 1.82821 -414 2 4.09536 18.4705 14.8092 8.9848 -0.155186 -10.4675 -415 1 7.11939 0.665063 18.3496 37.4596 -16.3367 -22.9959 -416 2 7.39046 0.248229 17.4868 -7.59422 10.3961 22.0522 -417 2 6.17976 0.73857 18.3349 -24.6121 7.91301 3.99406 -418 1 16.0679 18.4255 14.0033 46.948 4.07246 14.5496 -419 2 15.1925 18.2569 13.7481 -41.7006 -8.82757 -2.39817 -420 2 16.1514 18.46 14.9783 -11.5795 5.15321 -10.1321 -421 1 10.0899 4.51466 16.2755 46.1692 31.6348 -9.79269 -422 2 11.0262 4.80528 16.0633 -26.3332 -3.27592 13.4521 -423 2 10.217 3.58436 16.3451 -11.2214 -29.3564 0.661634 -424 1 15.916 17.7977 4.41903 32.6965 1.49817 -6.30174 -425 2 16.457 -0.0326327 4.45612 -4.70593 -7.03645 1.74937 -426 2 15.0663 18.0576 4.73092 -30.5769 8.16516 8.13282 -427 1 7.01211 17.4116 13.808 -11.1093 -0.0306798 -7.53718 -428 2 7.48321 17.731 14.5797 1.71822 -1.35338 6.01299 -429 2 7.70771 17.2257 13.1599 -0.832239 2.47859 1.40448 -430 1 13.2731 6.49483 6.63036 5.49864 12.0855 21.8831 -431 2 14.0036 7.1367 6.53142 -6.95912 -13.4785 -6.50558 -432 2 12.9191 6.26998 5.7719 1.78547 5.07661 -13.1828 -433 1 7.78873 2.35817 9.26787 13.6578 7.92928 32.9359 -434 2 7.26595 2.28464 10.098 4.41261 -4.66671 -14.4408 -435 2 7.24114 2.08424 8.54668 -18.4281 -7.28868 -15.4379 -436 1 15.1807 14.8213 13.6836 12.0158 -14.5979 1.51453 -437 2 15.023 15.1631 14.5679 -5.44227 3.64048 5.06686 -438 2 14.7818 15.3898 13.0312 -8.03448 9.52233 -3.65179 -439 1 9.37687 8.31604 3.76928 5.34304 4.19186 5.02399 -440 2 10.2244 8.59911 4.15846 -6.46746 6.21109 -7.45595 -441 2 9.38739 7.36131 3.86692 -0.369722 -6.10407 -0.56198 -442 1 17.7826 13.5587 16.3931 -18.259 -13.3606 7.93732 -443 2 16.8564 13.2543 16.3515 3.23179 3.05811 2.18424 -444 2 17.7493 14.412 15.956 6.45918 8.6709 -4.68033 -445 1 4.96945 10.6182 2.7671 -20.0352 21.3698 -14.9929 -446 2 5.67156 10.2863 3.30832 14.7689 -7.42384 15.9186 -447 2 4.73305 11.5 3.12196 4.54065 -18.1741 -2.81522 -448 1 3.75186 8.34553 10.1595 -2.54049 11.5371 -18.7835 -449 2 3.83158 9.28658 9.87851 -1.62744 -10.9109 6.60301 -450 2 3.69687 8.33176 11.111 2.12623 4.07512 13.0596 -451 1 16.0105 7.02075 6.14683 -8.93467 17.9282 -2.69417 -452 2 16.8191 7.42843 6.45697 9.04966 6.41713 2.22097 -453 2 16.1641 6.09023 6.1704 3.21598 -21.4167 -2.94797 -454 1 15.1148 7.07457 9.06702 4.51295 -11.3361 21.5265 -455 2 15.7278 7.43111 9.72685 3.64545 -0.886375 -6.04752 -456 2 15.1684 7.6713 8.33808 0.281889 14.352 -20.2518 -457 1 6.32562 13.0044 12.7823 3.64263 -12.4915 -10.2251 -458 2 7.18031 12.5985 13.0233 -9.44077 2.88231 5.28619 -459 2 6.10277 13.6925 13.4113 4.07235 10.5841 12.4872 -460 1 12.13 4.50388 13.0978 -23.9143 -18.2098 -29.5576 -461 2 12.2018 4.66005 14.0386 -4.52664 -3.61945 12.4396 -462 2 11.31 3.95423 12.8708 29.5104 21.9629 17.7949 -463 1 11.3628 8.1671 7.89263 -5.63688 4.26156 -3.21905 -464 2 12.0486 7.63378 7.48497 5.26632 -9.68169 -9.18733 -465 2 11.6596 8.25059 8.79652 3.08614 3.11673 13.4283 -466 1 17.1728 10.8467 7.48683 -9.78257 9.61375 -3.53187 -467 2 17.8082 10.1926 7.21604 13.2987 -16.4259 3.23364 -468 2 17.1151 11.4269 6.71399 -11.2446 1.98681 4.69156 -469 1 5.26156 18.1118 11.0164 11.279 0.780011 3.76881 -470 2 4.63029 17.9037 11.706 -3.79608 -1.61163 6.00067 -471 2 4.75114 18.4846 10.3039 -10.5863 -2.03901 -14.6626 -472 1 7.60927 17.5116 1.80376 -12.2084 0.332405 -16.0787 -473 2 7.73547 16.6894 1.27511 4.49641 20.7738 7.60921 -474 2 7.29137 18.2078 1.17993 10.7818 -15.1152 7.96202 -475 1 1.93242 12.9038 13.5907 -11.1009 -8.62515 -2.91716 -476 2 1.44204 12.3193 14.1878 -0.742257 0.132846 -0.79095 -477 2 2.14259 13.6778 14.1103 6.96653 11.7909 8.84583 -478 1 9.6349 6.79099 14.8483 -7.90933 -4.5792 7.57822 -479 2 9.76837 5.84646 15.0736 0.917781 12.494 -4.6794 -480 2 9.97866 6.97841 13.9703 0.736717 -7.57275 -8.26148 -481 1 15.2733 4.3257 10.7584 -18.0594 -0.89979 -6.45033 -482 2 16.1458 3.96681 10.9687 3.533 12.3702 4.36819 -483 2 14.9475 4.94569 11.4317 15.7147 -3.56113 0.605423 -484 1 11.2438 6.16931 0.179082 0.0277951 -2.16566 -3.90965 -485 2 11.3357 5.30361 18.4317 14.8036 -12.0621 -1.88578 -486 2 10.2956 6.2638 0.1816 -11.5861 14.503 2.02073 -487 1 0.0439986 11.3816 15.0585 -6.49496 4.09431 2.20477 -488 2 18.034 11.5578 14.353 7.75523 3.54925 4.26198 -489 2 -0.111373 12.1024 15.7029 3.25408 -7.01329 -10.5532 -490 1 7.06114 9.23722 7.26386 23.5376 12.3273 -0.106793 -491 2 6.50127 8.56776 7.63843 -10.2441 -19.5548 5.03643 -492 2 7.97426 8.90952 7.38371 -13.166 2.65106 -3.29749 -493 1 18.3483 15.3728 12.3401 -6.10947 1.64082 -0.490965 -494 2 0.640544 15.4003 12.1341 13.3619 2.30286 0.418231 -495 2 17.9315 15.8707 11.6253 -4.70162 -1.66258 -3.35097 -496 1 16.5284 4.37134 5.23872 23.865 15.8443 -24.0922 -497 2 16.795 4.23475 6.13242 -1.17196 -10.8972 27.7735 -498 2 17.3848 4.63349 4.80865 -25.3878 -11.1359 -1.24016 -499 1 17.7266 3.13043 10.7284 -15.1505 -16.4799 -4.03799 -500 2 -0.0205156 3.31599 11.0266 10.8372 -1.61224 -0.261482 -501 2 17.686 2.21262 10.3629 5.98361 15.5222 5.29053 -502 1 12.2768 0.00077952 10.1229 -5.39949 -11.0736 -0.564535 -503 2 11.3994 0.337416 10.3512 -3.44242 -0.519791 1.58275 -504 2 12.8621 0.740723 10.2534 12.1364 13.942 1.61795 -505 1 10.3933 9.78571 12.4371 -17.696 -6.66554 -9.33286 -506 2 11.04 9.8019 13.1479 9.02187 0.111511 2.28178 -507 2 10.1583 8.84624 12.3274 6.95171 5.58218 -0.582165 -508 1 0.583846 2.83323 7.01904 8.81732 -31.8654 7.83245 -509 2 0.599611 3.49885 7.68934 -3.58556 22.6003 9.07619 -510 2 0.952398 2.07883 7.51841 -6.10214 6.37924 -11.0018 -511 1 0.367433 15.2949 6.92522 -4.7012 3.61818 34.4112 -512 2 0.558547 14.7156 7.70153 -1.71176 22.246 -5.06421 -513 2 0.60814 14.7658 6.19753 10.4713 -26.0103 -27.8181 -514 1 17.0409 7.00624 15.2099 -22.5014 1.92016 -1.24665 -515 2 17.7387 7.65639 15.0691 10.2085 -5.07189 3.59706 -516 2 17.3996 6.21947 15.6455 8.09739 1.82665 -3.45815 -517 1 9.08645 12.4582 8.07298 60.2845 4.68897 0.226728 -518 2 9.45122 11.8173 7.41895 -17.2892 5.38378 7.41181 -519 2 8.16079 12.445 8.11596 -46.4448 -7.25102 -10.4423 -520 1 1.26434 1.84534 2.97351 6.14985 -4.32801 10.6126 -521 2 0.602074 2.03133 2.30849 -1.31532 11.5451 -8.74279 -522 2 1.61884 2.681 3.33622 -3.80121 -10.2767 -5.51985 -523 1 4.10472 15.1163 9.79145 -1.9934 -0.675971 8.59173 -524 2 4.064 15.4281 8.88095 5.53492 -3.39313 -4.80569 -525 2 4.98866 14.7298 9.93327 -5.1567 4.83883 -4.62826 -526 1 7.25259 2.18349 14.6213 0.0617677 -13.2081 -4.74626 -527 2 7.15489 1.70536 13.7831 -3.1697 0.657011 7.79217 -528 2 7.60954 3.02479 14.3607 5.63067 15.2107 -2.58221 -529 1 18.5424 14.6505 2.1789 -18.2195 12.8357 -3.23587 -530 2 0.746704 15.0923 2.14855 14.3998 1.01071 2.70778 -531 2 17.888 15.3836 2.15154 2.4051 -14.4939 -0.146303 -532 1 9.96619 2.7451 12.9133 2.94451 10.1866 18.8487 -533 2 9.87163 2.03702 12.2777 -5.79326 -7.02869 -14.8001 -534 2 9.15272 3.27293 12.9211 3.46257 -1.15836 -6.04557 -535 1 2.89008 8.93457 13.069 -0.378913 -4.03455 -0.489948 -536 2 3.23396 9.82093 12.8894 1.3587 3.50504 -2.14294 -537 2 3.63423 8.44035 13.4383 1.00579 -2.11175 -2.13579 -538 1 3.23705 8.4538 3.70316 6.66602 15.0067 -51.1451 -539 2 3.68898 9.21355 3.2191 -13.1992 -22.9024 22.1933 -540 2 3.37321 8.55056 4.62635 6.35333 11.1623 30.2444 -541 1 5.63533 7.19464 8.56829 15.13 5.19196 -11.3333 -542 2 5.75579 6.23215 8.63413 -6.09463 5.83127 4.58457 -543 2 5.06463 7.50349 9.27803 -5.30623 -7.19668 4.50769 -544 1 14.8805 1.37043 1.98087 -12.9306 20.6627 -0.801435 -545 2 14.4834 2.20569 2.28334 5.69168 -11.9007 13.5915 -546 2 15.1168 1.59638 1.09054 15.1066 -6.121 -14.4277 -547 1 8.35206 15.1867 0.801551 -2.76223 -14.7585 -5.29804 -548 2 9.12264 14.9643 1.32951 11.031 8.33032 8.58299 -549 2 7.67017 14.6008 1.15941 -5.63761 -0.337967 -3.00039 -550 1 15.5896 1.3528 7.2086 5.32958 13.3681 13.2076 -551 2 15.0272 0.817571 6.66531 -11.4451 -13.4108 -9.89715 -552 2 14.9993 2.0562 7.52457 4.21653 3.3566 -1.64766 -553 1 5.02591 13.0452 18.4884 -9.20414 -3.59717 -21.6247 -554 2 5.46138 13.1397 0.681872 7.63488 2.92653 16.7381 -555 2 5.72796 13.1696 17.8326 -7.15584 3.38504 4.08457 -556 1 15.3795 8.51367 18.1423 -0.613664 -0.0581633 13.6311 -557 2 15.7206 8.99589 17.3938 3.47957 9.7554 -12.9134 -558 2 15.3333 9.18442 0.205917 -4.60531 -6.1888 -2.54679 -559 1 12.0939 3.05244 18.336 -15.98 21.6351 4.66001 -560 2 12.5019 2.66242 0.476891 0.147771 -8.75739 -8.71627 -561 2 12.3559 2.60872 17.5248 9.46456 -12.7769 5.34739 -562 1 13.1875 12.6757 5.16147 -9.52799 6.20775 -2.46737 -563 2 13.6969 11.8811 4.95337 3.5398 -1.69434 3.58065 -564 2 13.2525 12.8475 6.11376 6.90446 -8.64397 -1.04625 -565 1 6.03627 7.1613 0.0926319 -1.4976 11.1377 0.14104 -566 2 5.76921 8.10211 0.154014 9.70457 -9.32393 -3.08293 -567 2 5.20613 6.68485 0.159604 -1.55619 -3.41243 3.21991 -568 1 17.685 15.9184 14.9825 -1.37425 0.537856 -17.3926 -569 2 16.8502 16.3506 14.966 -20.4161 12.6054 20.7942 -570 2 17.7239 15.7506 14.0369 24.1644 -10.6132 -5.26117 -571 1 13.1805 0.948047 16.6125 -8.26177 1.73564 3.5107 -572 2 14.0455 0.715926 16.9626 7.25254 0.595142 -3.17693 -573 2 12.7267 0.0993777 16.5408 2.533 -1.4889 -4.3323 -574 1 11.0204 14.5878 7.33132 -13.7805 -25.7938 -0.586216 -575 2 10.2983 13.987 7.62969 9.87943 15.8321 -1.01987 -576 2 11.8217 14.058 7.45361 -0.254224 3.6388 3.5388 -577 1 17.5119 8.53957 2.08465 9.75653 -12.9638 -10.6953 -578 2 16.6633 8.36471 2.52368 3.0717 -2.74041 -4.8374 -579 2 17.6343 7.8268 1.40004 -7.84255 17.4574 20.9547 -580 1 12.3495 7.93856 1.97915 15.2682 -24.1922 3.95646 -581 2 11.8245 8.73298 1.97607 -8.33179 10.3297 -5.28986 -582 2 12.0289 7.32679 1.29658 -2.64171 9.95394 1.06163 -583 1 11.9622 14.6462 10.3592 5.19436 44.1652 25.6085 -584 2 12.1561 13.8266 9.98193 3.67183 -41.4058 -22.2867 -585 2 11.0169 14.8072 10.2884 -7.2612 -3.28322 -4.25289 -586 1 6.85285 6.99572 15.5659 -14.0155 -24.0568 -12.8099 -587 2 7.75988 6.91015 15.2685 9.48733 7.04308 1.07731 -588 2 6.80041 7.76332 16.11 4.63477 18.9896 15.1539 -589 1 8.01222 4.65145 13.4113 -36.8067 -34.3033 -31.6859 -590 2 7.3316 4.83402 12.7007 16.1602 -3.60309 24.697 -591 2 8.38377 5.47541 13.6286 15.6027 34.5994 6.21753 -592 1 13.4241 12.174 14.3057 -4.84328 6.02619 2.2323 -593 2 13.1628 11.2453 14.2138 0.984992 -0.986947 -4.38535 -594 2 13.8661 12.446 13.4834 -0.550032 -4.72607 1.54363 -595 1 14.7341 9.44221 7.2791 -5.07947 3.15833 13.2143 -596 2 15.5444 9.94699 7.52972 -16.5583 -4.09464 -2.76463 -597 2 13.9842 9.66778 7.87655 21.0159 1.38057 -11.435 -598 1 12.706 16.9897 3.14089 12.6698 -33.6085 3.29803 -599 2 12.7844 17.2146 4.05845 5.40916 5.57996 15.4808 -600 2 12.1668 17.6603 2.78193 -20.8699 29.0634 -19.4792 -601 1 1.09001 7.14262 17.4001 -13.5934 2.13623 7.48936 -602 2 0.156991 7.24832 17.6908 14.7769 -7.58529 -2.77652 -603 2 1.13731 7.55625 16.5284 -2.3111 1.37932 -0.487878 -604 1 12.8562 5.06495 15.6988 -8.68567 -0.702669 -5.76624 -605 2 13.5471 4.4122 15.5538 8.1837 -6.12965 4.55719 -606 2 13.3218 5.91347 15.6395 -0.893164 2.09785 3.54679 -607 1 2.45402 3.36746 5.11563 -15.0026 -7.91555 0.636238 -608 2 1.84292 3.24382 5.86687 4.72922 -2.7794 -8.95345 -609 2 2.91216 4.18226 5.3072 9.55717 10.9124 5.44962 -610 1 8.31869 11.1649 13.5414 -26.3953 31.2189 -67.0184 -611 2 8.3305 10.9362 14.4299 14.6498 -23.9054 54.2316 -612 2 8.96182 10.7076 12.9898 15.0794 -7.45176 14.931 -613 1 12.9219 1.43726 13.3082 8.40674 -27.4269 12.3988 -614 2 13.6356 1.33586 12.6838 7.08718 -5.3 -10.143 -615 2 12.6036 2.28403 13.0872 -17.61 33.9058 -2.44667 -616 1 6.45277 13.6094 2.15178 17.7292 -13.553 0.669437 -617 2 5.88225 13.9257 2.84987 -12.2826 9.62032 8.12495 -618 2 7.05696 13.0019 2.62135 -3.25561 7.9246 -7.28354 -619 1 15.9319 6.53462 12.7261 -1.3149 8.22476 -13.019 -620 2 16.4256 7.00237 12.02 -4.18033 -7.18445 13.3481 -621 2 16.3662 6.74364 13.5705 0.249391 -3.37031 -2.78146 -622 1 16.8119 0.703827 9.59317 0.0549178 13.2549 -11.7388 -623 2 16.9772 18.4048 9.65541 -4.88295 -11.6626 5.05601 -624 2 16.4803 0.847119 8.68154 -1.08178 -1.2883 7.79904 -625 1 6.11652 11.6489 8.33522 -7.45125 2.78057 4.10213 -626 2 5.22601 11.4682 8.68918 7.08294 1.77705 -0.544493 -627 2 6.44454 10.7788 8.07724 4.19277 0.895061 -4.04259 -628 1 2.82334 8.71064 0.367814 57.5944 7.33247 25.2144 -629 2 2.2601 8.16366 18.5098 -36.527 -13.587 -20.7071 -630 2 2.37171 9.41868 0.829256 -17.9324 0.137834 -3.43482 -631 1 10.1122 10.4601 6.54653 2.23323 -6.08635 8.59596 -632 2 10.5188 9.74717 7.06727 -1.60105 2.20328 -1.71973 -633 2 10.6949 10.5759 5.79445 1.91861 -2.10956 -11.6412 -634 1 6.75321 15.7504 6.59889 15.4627 0.902891 -8.22878 -635 2 7.26857 15.9454 7.3825 -2.17992 1.48032 8.28293 -636 2 7.22097 16.2558 5.90647 -13.1985 0.138133 2.05084 -637 1 6.44152 13.0383 5.65846 10.3967 8.14078 0.466175 -638 2 6.75357 13.9433 5.8413 -7.70657 -8.59676 1.70002 -639 2 6.06189 12.7174 6.48437 -0.213232 -3.44089 0.434225 -640 1 16.7867 12.5398 9.78373 -0.895423 12.3409 14.8939 -641 2 16.908 11.9251 9.05274 5.68732 0.178616 -8.50939 -642 2 17.2058 13.3939 9.58039 -4.06144 -12.2084 -5.14549 -643 1 6.11722 2.93773 2.78358 1.28645 13.216 -7.71479 -644 2 6.25944 3.86133 2.4934 3.99356 -9.45804 11.966 -645 2 5.80949 2.50246 1.9813 -4.27697 -8.38821 -0.209888 -646 1 10.8697 3.19981 3.26527 3.50346 -2.80617 2.55973 -647 2 10.3917 4.00785 3.47818 -6.11785 -2.03152 -1.59068 -648 2 10.4869 2.83625 2.45753 -2.48553 0.910808 2.03729 -ITEM: TIMESTEP -50 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.80494 6.94654 17.8995 24.4982 -1.06408 -3.00226 -2 2 7.9626 7.14317 18.2754 -25.5132 0.779993 7.28642 -3 2 8.754 6.09075 17.4755 -3.81212 -4.80634 -6.17786 -4 1 18.7076 8.28828 6.77862 -17.6183 19.7289 -45.7057 -5 2 0.378325 8.05756 5.8509 -9.14495 4.02657 32.4311 -6 2 0.533056 7.77742 7.41073 20.0311 -22.8668 16.2585 -7 1 8.47587 18.7144 6.8555 -15.9357 -0.720841 9.56566 -8 2 9.33674 0.260611 6.50709 17.8925 2.772 -5.71063 -9 2 7.894 0.699709 6.41588 1.40147 0.745568 -0.352682 -10 1 6.55032 1.74908 11.6806 -30.6389 -0.0206495 8.42613 -11 2 5.72229 2.20254 12.0188 30.9536 -14.8428 -8.23206 -12 2 6.26581 0.83583 11.4478 2.55871 18.5754 3.76962 -13 1 7.01034 5.66598 2.40366 42.8029 -38.9731 -13.6875 -14 2 6.35895 6.02285 2.96016 -30.9745 25.4116 27.1882 -15 2 6.9342 6.07183 1.55014 -9.7244 15.1829 -13.9093 -16 1 16.2046 10.2277 16.1038 24.2393 -12.7483 3.49627 -17 2 17.1446 10.5017 16.2161 -25.4373 -4.23616 -6.12234 -18 2 15.647 10.9645 16.3441 -0.0961828 13.5193 2.91036 -19 1 10.6483 14.9468 2.32679 16.6528 15.7411 4.7381 -20 2 10.6274 14.3584 3.09768 -0.623134 4.2367 -1.18236 -21 2 11.2712 15.6715 2.59359 -14.1521 -13.9994 -5.33424 -22 1 17.1661 8.23718 10.6306 -11.2967 1.73071 14.301 -23 2 16.7507 8.8212 11.3018 1.93853 -3.53361 -12.158 -24 2 17.9019 8.73965 10.2686 8.0864 2.26419 -0.719652 -25 1 14.7146 15.8737 16.457 -21.3602 13.4439 -13.9077 -26 2 13.7676 16.1527 16.3582 25.6738 -5.80999 2.03747 -27 2 14.7447 15.4629 17.3289 2.78446 -2.53877 0.107495 -28 1 12.1127 13.3961 0.516068 7.29043 -9.0569 -3.36162 -29 2 11.9491 13.4845 18.198 -4.88029 1.64951 11.237 -30 2 11.4672 13.8878 1.04861 1.29785 5.2885 -8.15688 -31 1 9.32313 5.46813 3.97213 7.80738 6.41636 -30.8752 -32 2 8.77956 5.22076 4.69796 -14.0602 -7.63701 27.6376 -33 2 8.66617 5.58024 3.26537 2.47672 -2.22308 0.129141 -34 1 1.75935 4.12111 11.6197 18.1342 -37.205 15.7411 -35 2 1.54791 5.00495 11.8916 -2.97584 25.4072 4.68628 -36 2 2.32145 3.72177 12.3424 -17.0092 10.631 -21.3466 -37 1 2.03979 6.80407 8.28533 9.98525 11.4794 16.6393 -38 2 2.53906 7.28349 8.98677 -9.97253 -7.08615 -13.1486 -39 2 1.84044 5.93856 8.67612 2.99865 2.8006 -7.53122 -40 1 5.41368 4.4431 7.98609 2.04847 -7.17668 -5.4397 -41 2 5.52021 3.53426 7.6768 1.69988 -8.04832 10.7211 -42 2 4.8597 4.83563 7.32005 -13.574 8.98698 -13.1921 -43 1 3.28639 2.94557 17.481 18.7711 -22.2673 -22.0629 -44 2 3.9564 3.24513 16.8336 -6.74837 -1.29983 9.82734 -45 2 3.01936 3.73284 17.9334 -14.3576 17.7403 14.3716 -46 1 7.43065 5.38409 6.1108 -4.02947 -12.3157 -7.88053 -47 2 8.04294 5.88377 6.62432 18.8075 23.5792 8.00277 -48 2 6.91671 4.96856 6.79731 -10.3369 -11.1081 4.55684 -49 1 9.79016 6.98523 11.9902 -10.4204 5.88316 -11.2143 -50 2 10.3735 6.44493 11.4296 -8.50476 3.87141 4.17676 -51 2 9.02941 7.28204 11.4255 18.3189 -8.29917 9.01359 -52 1 14.0741 3.64931 8.08693 10.5401 -0.215179 40.0548 -53 2 14.0167 4.44403 7.56769 -3.75439 10.9765 -10.3635 -54 2 14.3054 3.9684 9.00291 -5.13065 -9.75311 -28.2231 -55 1 4.53282 17.2396 3.96388 -3.36194 -12.9595 16.5635 -56 2 5.47422 17.3897 3.95236 14.0752 8.1678 -3.62607 -57 2 4.10275 17.6636 3.22639 -0.935466 5.38311 -16.6052 -58 1 16.4462 16.5922 10.2581 -38.5234 -1.88036 17.4962 -59 2 15.5721 16.6729 10.7424 33.2408 0.640367 -11.4138 -60 2 16.1948 16.0519 9.4989 1.36351 -0.703045 -4.07641 -61 1 1.99534 4.82647 0.326236 -5.72725 6.00108 -15.6714 -62 2 2.53752 5.17962 1.03714 5.87953 4.50688 4.90779 -63 2 1.76739 5.60304 -0.220726 -2.02535 -4.08014 4.56707 -64 1 11.5531 13.2812 16.3325 -4.55485 8.80091 5.86354 -65 2 11.0534 12.4701 16.4457 -6.69668 -7.45166 4.31247 -66 2 12.0841 13.1031 15.5561 8.82157 3.01133 -6.78989 -67 1 10.1577 11.0139 16.8858 -24.3839 23.6532 0.592397 -68 2 10.5791 10.1721 16.8528 10.3809 -28.4273 -2.47871 -69 2 9.20446 10.8554 16.7431 9.15295 -0.788439 1.53623 -70 1 11.769 17.4436 13.4724 -4.31264 31.1905 -3.85112 -71 2 12.3451 17.016 12.8258 4.51875 -1.42135 -0.782751 -72 2 11.9049 18.418 13.331 2.02313 -21.8103 4.25856 -73 1 6.43699 9.33747 12.2016 -14.3685 16.3251 29.571 -74 2 6.95929 8.94901 11.512 13.8657 -1.33735 -10.2504 -75 2 6.99936 9.91985 12.7612 -5.52999 -10.4188 -15.163 -76 1 16.2506 12.8362 2.68463 10.4823 17.07 -2.68352 -77 2 17.0784 13.3466 2.55935 -9.20242 -14.0812 1.4249 -78 2 15.565 13.5285 2.65461 0.126865 -8.38924 5.57615 -79 1 0.688432 12.6159 5.91845 40.3739 4.73102 13.6953 -80 2 0.965548 12.5027 5.00914 1.60296 -4.44104 -10.7732 -81 2 18.4099 12.7183 5.90627 -44.0147 0.977299 -7.7541 -82 1 5.23962 16.4285 18.4285 2.37714 -1.84876 8.0205 -83 2 5.78786 15.7427 18.0572 3.65919 -12.8888 -12.968 -84 2 5.57695 16.4825 0.678793 -3.22986 7.92557 6.36641 -85 1 0.598604 7.70507 4.14138 -20.7786 -13.2635 7.16681 -86 2 18.6305 8.09263 3.50172 -0.345103 1.12768 -4.13337 -87 2 1.46117 7.8354 3.77399 24.2365 9.84596 -7.22116 -88 1 3.12664 8.94501 6.49467 58.7355 2.96877 -21.5552 -89 2 3.79065 8.46432 7.02112 -12.6266 6.35685 -1.15291 -90 2 2.29097 8.86083 6.88074 -41.9399 -6.12221 23.1652 -91 1 7.26988 10.3368 16.2836 11.5372 -0.463039 -18.2668 -92 2 6.61986 10.5879 15.6307 -2.48374 3.02842 -3.04887 -93 2 6.78814 10.3049 17.1036 -3.00573 -3.18181 16.2709 -94 1 11.123 0.978368 5.0094 -10.4546 8.12706 3.20432 -95 2 11.0717 1.86722 4.62246 7.34447 -2.45893 1.30193 -96 2 10.765 0.419141 4.31729 -2.84542 -7.68945 -6.73121 -97 1 4.36745 2.7997 13.2283 -2.96005 27.1446 -27.16 -98 2 4.67681 3.13482 14.0684 -0.492375 -1.19152 9.60175 -99 2 4.17697 1.87548 13.305 -2.22526 -24.419 13.8486 -100 1 8.37947 10.1962 1.80259 -4.93469 16.4683 -10.3397 -101 2 8.22749 10.8872 2.46356 1.16914 -1.49574 -1.6966 -102 2 8.71062 9.47199 2.30942 8.47484 -21.3721 12.0127 -103 1 10.3811 1.71408 15.5377 20.686 0.359172 -10.6925 -104 2 11.354 1.66546 15.4316 -15.8773 -5.06945 10.6173 -105 2 10.0964 2.02238 14.6685 -5.35844 0.742925 -2.36882 -106 1 2.68357 12.8347 7.81396 4.59418 8.51704 7.17464 -107 2 3.18489 13.5948 7.4697 -3.72618 -6.19027 -0.541735 -108 2 1.90686 12.7457 7.24856 2.42229 -2.05385 -5.50174 -109 1 3.74169 11.6981 5.12659 20.4064 16.2552 5.07347 -110 2 3.6031 10.8525 5.51837 -2.34348 -17.0347 14.1119 -111 2 3.05756 11.7956 4.48632 -17.1397 4.43934 -14.0111 -112 1 6.78306 14.4202 16.945 8.30127 18.455 -2.7408 -113 2 7.70256 14.7228 17.0235 -7.00262 -4.27134 -0.857039 -114 2 6.4289 14.8468 16.1479 2.30915 -9.19793 -2.69046 -115 1 14.2185 14.5268 3.31588 -23.2154 9.18115 10.9982 -116 2 13.6682 15.2954 3.06852 12.5657 -5.26706 1.63848 -117 2 13.7604 14.1667 4.10581 9.83524 -2.33371 -14.8176 -118 1 8.44676 18.1227 16.0393 7.73472 16.3177 -1.68025 -119 2 9.01165 17.3799 16.1525 3.2644 -34.6246 10.2309 -120 2 9.11477 0.14931 15.8801 -4.9724 20.6673 -2.43491 -121 1 4.70679 1.64341 4.91058 -17.3364 -32.3489 41.2122 -122 2 3.86106 2.04855 5.10849 -6.14561 5.35271 -2.51022 -123 2 5.03045 2.1011 4.1778 23.045 28.1017 -39.82 -124 1 14.9769 12.6712 16.4491 28.5182 -25.5733 -37.1858 -125 2 14.5585 13.1664 17.1249 -24.0861 16.0366 17.7329 -126 2 14.4092 12.4828 15.6576 3.30334 14.0855 25.2157 -127 1 15.7195 18.4537 16.8862 -41.4911 -4.79998 -47.5194 -128 2 16.474 18.4695 17.416 41.6971 -5.3201 37.0536 -129 2 15.5173 17.5216 16.6763 -0.165283 4.31671 10.9236 -130 1 1.26675 1.20722 16.5821 1.91531 -3.73727 -7.96899 -131 2 2.06576 1.68562 16.7995 9.77153 8.32265 -0.296149 -132 2 0.695796 1.45596 17.2985 -12.9769 2.74169 12.7471 -133 1 18.1595 4.46894 15.9392 -8.68238 9.49864 15.6389 -134 2 18.21 4.01948 15.1094 2.12602 -9.4702 -15.5502 -135 2 0.321646 4.30297 16.4236 6.52219 -0.344151 0.382064 -136 1 12.2433 16.9631 16.1365 30.1535 25.9085 -42.0202 -137 2 11.4764 16.7912 16.6244 -43.4812 -17.6238 21.6018 -138 2 11.9609 17.1491 15.2014 5.35486 -10.4534 20.1012 -139 1 16.0404 2.55502 18.1172 12.6912 -10.4842 9.42679 -140 2 15.6589 3.39683 18.3503 -6.59057 14.1496 4.33812 -141 2 15.9441 2.46009 17.1755 -7.16214 2.08136 -15.1428 -142 1 6.70635 13.8458 10.192 -16.5385 -19.5662 -16.6234 -143 2 6.46743 13.4829 11.0519 3.62966 4.37567 6.36784 -144 2 6.41781 13.1513 9.56037 11.5929 10.5707 5.5488 -145 1 10.1419 18.3987 2.73425 -19.4638 -25.4286 12.0097 -146 2 10.2073 0.494584 2.15475 6.00155 18.7458 -18.7245 -147 2 9.2799 18.0069 2.48337 13.6051 6.39322 6.25061 -148 1 3.04438 17.7185 6.11283 5.61436 7.93422 -10.0091 -149 2 2.18521 17.5434 5.71014 -2.22655 1.93918 -4.29169 -150 2 3.60431 18.0006 5.35738 -6.06642 -9.44159 14.8188 -151 1 12.59 16.8727 7.99688 3.41749 0.26688 0.968442 -152 2 11.9163 16.1959 7.96054 -9.29683 -10.0995 -8.1817 -153 2 12.3648 17.371 8.78825 5.01363 9.11979 0.25951 -154 1 14.8925 15.2941 8.21002 11.8118 0.190541 -21.4145 -155 2 14.0466 15.7377 8.15471 -7.99071 7.70949 7.81769 -156 2 15.2804 15.4945 7.32486 -0.0803457 -7.85257 22.8773 -157 1 17.7158 18.2428 0.330134 42.1686 22.2301 9.80157 -158 2 18.5718 17.7519 0.320787 -20.6577 0.0591745 -9.59458 -159 2 18.0296 0.514827 0.540707 -19.3386 -19.3229 -5.27308 -160 1 0.848087 10.4587 1.36302 27.1846 51.9138 -28.6855 -161 2 0.125428 9.973 1.66463 -44.0007 -34.6793 17.9508 -162 2 0.450253 11.2027 0.827225 17.544 -22.8417 14.6566 -163 1 1.73752 12.2317 3.35921 -10.6222 -3.23772 -40.3174 -164 2 1.50468 11.5771 2.65039 3.80547 3.73659 24.0112 -165 2 1.78112 13.0447 2.82871 4.93945 -0.670418 11.0651 -166 1 0.61763 17.2312 4.89977 -31.3278 9.09129 49.7394 -167 2 18.753 18.067 4.93438 12.2337 -8.61092 -13.4292 -168 2 0.309388 16.8063 5.75223 19.8395 0.744545 -34.548 -169 1 1.12081 0.925337 9.40389 -12.5044 -10.6635 0.652446 -170 2 1.34187 0.581545 10.2981 -6.32089 4.74016 -12.6461 -171 2 0.253358 0.524348 9.17819 18.5788 9.22491 5.8567 -172 1 16.7331 2.36195 13.2995 -4.07693 -18.6231 24.2357 -173 2 16.9587 2.56306 12.4093 5.05193 8.99127 -27.3142 -174 2 16.5121 1.41005 13.3069 2.86591 9.33714 2.00751 -175 1 2.6752 15.8404 12.084 -17.9655 13.8891 -13.7444 -176 2 3.1007 15.4046 12.7977 10.8605 -10.5552 20.9848 -177 2 3.18035 15.6022 11.2985 0.61387 1.79975 -2.62876 -178 1 16.4324 15.6688 6.07894 -11.0906 -29.1832 8.11987 -179 2 17.3135 15.6699 6.4691 2.82688 3.86386 -3.5648 -180 2 16.3493 16.3586 5.42897 4.86465 16.2346 -9.8305 -181 1 5.78229 5.11191 11.8099 -13.8406 10.2937 3.29755 -182 2 5.26053 5.84491 12.2174 12.8802 -11.8636 -2.84442 -183 2 5.17337 4.36282 11.7377 2.58239 3.92087 3.15374 -184 1 15.1463 4.86734 0.794152 0.864651 12.4924 -33.9562 -185 2 14.9842 4.50309 1.65022 -3.17819 -5.74322 26.2661 -186 2 14.3662 5.39647 0.571272 5.91156 -4.56503 2.45287 -187 1 16.3343 16.3902 2.05204 -8.53913 3.9795 31.3204 -188 2 16.0972 16.7844 2.93864 3.99019 -13.2916 -26.145 -189 2 16.6713 17.1379 1.5654 4.18336 9.27065 -12.2854 -190 1 0.251768 4.84384 3.8243 -5.07672 -49.1083 -0.618349 -191 2 0.303365 5.75864 3.98841 7.12191 44.1717 7.46524 -192 2 0.849427 4.39339 4.43966 -1.76195 8.48948 -7.42491 -193 1 2.97026 15.0637 15.1648 0.961584 14.1925 -19.6325 -194 2 2.86359 14.8338 16.0871 -5.01806 -10.0022 10.5852 -195 2 2.57214 15.9549 15.1104 2.70735 -9.48442 0.706884 -196 1 1.14871 14.6442 9.53518 -42.8529 -19.211 3.24989 -197 2 2.06628 14.849 9.52706 28.3433 -3.949 4.37311 -198 2 1.01023 13.7361 9.90627 12.772 19.4662 -8.86837 -199 1 13.5229 16.5669 11.532 20.3549 -23.4698 16.7524 -200 2 13.3606 17.2446 10.8944 -12.6142 15.9017 -14.8664 -201 2 13.2357 15.729 11.1267 -5.06335 10.0173 1.96475 -202 1 4.64907 1.44855 0.782556 14.1843 16.2277 -15.4645 -203 2 4.13811 2.00007 0.175187 -1.198 1.13782 0.731863 -204 2 4.05002 0.760268 1.05534 -6.36237 -9.04178 10.9284 -205 1 1.45269 18.5669 11.8512 9.08594 -18.5638 20.5671 -206 2 1.3209 0.513151 12.6112 1.192 -1.45307 -0.682323 -207 2 1.82538 17.7349 12.2384 -6.22294 17.2853 -13.4176 -208 1 11.5083 10.14 3.99231 -12.3356 -6.67004 24.2683 -209 2 11.3008 10.4626 3.12291 -1.30093 6.41155 -12.7666 -210 2 12.4624 10.1697 4.04844 12.7044 -2.53047 3.95194 -211 1 8.22637 12.1595 3.70182 22.1984 -6.43536 -24.1249 -212 2 9.06359 12.543 3.994 2.39995 3.52197 1.898 -213 2 7.64229 12.2644 4.4292 -22.7553 4.87752 31.4773 -214 1 14.5041 4.04055 3.28708 -18.3332 1.47774 -0.327682 -215 2 14.9873 3.94029 4.11097 10.9182 2.80533 4.02706 -216 2 13.7169 4.55783 3.53097 2.05743 -3.46177 -0.871318 -217 1 5.62743 1.64825 7.52429 33.006 28.3977 -54.9531 -218 2 5.01294 1.12929 7.98513 -35.2623 -28.0367 23.7041 -219 2 5.43705 1.49837 6.5464 4.70081 6.15592 32.4881 -220 1 17.8649 1.10253 4.84999 -3.85271 -3.04411 9.89583 -221 2 18.5316 1.48406 4.28754 10.0589 0.579138 -13.4652 -222 2 17.9089 1.63153 5.65146 -2.44801 0.268727 5.2117 -223 1 6.82865 9.41118 4.50161 13.9732 -1.80028 18.7676 -224 2 6.94383 9.68391 5.43824 -8.65407 -5.40133 -16.2957 -225 2 7.70845 9.07477 4.25578 -5.27921 1.965 -0.840285 -226 1 2.66065 14.8943 1.98186 -2.57221 -9.24308 25.7982 -227 2 3.31586 14.7955 2.69868 -8.68087 -2.61777 -7.29774 -228 2 3.12007 15.367 1.30687 7.03004 7.53846 -18.6884 -229 1 17.3318 12.9277 13.2024 14.566 -8.41998 -6.98679 -230 2 16.4646 13.2932 13.3909 -3.11164 10.4066 0.365823 -231 2 17.9245 13.6681 12.9725 -15.6789 -3.68206 1.74475 -232 1 14.9332 10.5631 1.42248 26.9386 23.5346 15.1493 -233 2 15.5074 11.3103 1.7869 -22.4798 -24.8917 -12.2482 -234 2 14.0193 10.8096 1.5708 -2.19259 1.9486 -0.294463 -235 1 5.71089 6.73608 4.5629 -4.22281 28.118 -3.03355 -236 2 5.94827 7.69445 4.64343 -4.82413 -18.183 -7.3163 -237 2 6.31292 6.28304 5.16113 4.14578 -2.25186 0.1588 -238 1 7.97883 8.3192 10.3001 7.8407 -5.86676 -34.7961 -239 2 8.53275 9.01778 9.91692 4.61581 1.53144 9.76809 -240 2 7.67805 7.86001 9.48783 -4.88471 -0.599295 18.8237 -241 1 13.4226 18.4487 5.72909 4.08913 1.21656 -6.98532 -242 2 12.585 0.250804 5.52036 7.76092 4.80861 -0.84516 -243 2 13.2097 17.9386 6.50687 -2.642 -10.6174 11.5339 -244 1 0.0869602 2.62265 0.223952 -9.8031 -15.3274 -6.51765 -245 2 17.9117 2.88521 18.4333 -9.97249 -6.92357 5.22107 -246 2 0.604672 3.41479 0.198655 20.2406 16.0872 6.75582 -247 1 12.7806 11.0275 9.75202 47.836 -29.2198 23.6504 -248 2 11.892 10.9606 9.4924 -44.5823 -3.62186 -10.7645 -249 2 12.9839 10.1194 10.1272 -4.83434 23.2951 -13.1663 -250 1 0.705171 12.1501 11.0469 -11.5221 2.5881 -10.739 -251 2 18.3743 12.1368 11.1638 13.8029 4.27958 5.25964 -252 2 1.13401 12.4861 11.8379 -3.00537 2.27024 12.2218 -253 1 5.1174 7.31342 13.4172 11.1181 3.69095 0.765545 -254 2 5.61979 7.99643 12.9358 -2.94992 -2.73128 4.30069 -255 2 5.6521 7.15272 14.218 -5.77355 -1.15348 -7.33249 -256 1 1.197 6.86571 11.8595 38.3077 26.916 14.5555 -257 2 0.451078 7.27927 11.4324 -8.7071 4.85333 -5.01967 -258 2 1.83731 7.62187 12.0983 -31.0022 -32.2106 -6.42275 -259 1 15.4885 9.63727 12.3206 16.478 -29.8614 -10.1392 -260 2 15.1661 10.5006 12.1398 -12.0715 29.4427 -0.903292 -261 2 15.2587 9.41843 13.2151 -2.74274 1.51694 14.7591 -262 1 16.5678 12.6919 5.49509 2.68502 5.28083 21.2685 -263 2 16.324 13.6184 5.59953 -0.326156 6.48336 2.9395 -264 2 16.4016 12.5196 4.57887 -2.84479 -5.20052 -25.0662 -265 1 6.28213 9.87258 0.0490999 16.8985 1.83912 15.6964 -266 2 5.56262 10.3905 0.421328 -3.89363 2.12479 6.12138 -267 2 7.01982 9.90555 0.722608 -19.7924 2.8001 -17.1777 -268 1 12.2865 6.1036 4.06304 19.2748 24.5544 -29.5048 -269 2 12.3306 6.8161 3.36437 1.4085 -17.3408 22.8012 -270 2 11.3814 5.83426 4.0192 -21.2841 -11.2083 4.33393 -271 1 0.298047 12.7955 0.166375 -3.43648 3.64279 0.0778505 -272 2 -0.0290314 13.4316 0.817326 3.1389 2.62115 2.93426 -273 2 18.4391 12.9788 18.0124 -4.25126 3.67416 -7.60949 -274 1 3.647 18.6117 8.59889 -15.5834 11.8668 6.1299 -275 2 3.50703 18.267 7.70639 0.18727 -3.89186 2.0216 -276 2 2.76186 0.338497 8.83167 17.7751 -6.65964 -2.12733 -277 1 7.50606 17.376 4.49824 -10.0508 -46.4512 11.7168 -278 2 7.49016 18.3059 4.51667 7.03352 43.591 -0.815572 -279 2 7.72157 17.1186 3.60818 -1.05523 3.68228 -12.2984 -280 1 9.25162 17.1195 12.2401 -20.7119 -1.17481 -13.1138 -281 2 9.34873 16.3083 11.723 0.965197 -1.09758 -0.258815 -282 2 10.0653 17.2534 12.7074 19.1017 -2.42392 11.5163 -283 1 13.35 12.9891 7.98546 26.3101 20.7404 -8.62941 -284 2 13.4089 12.1901 8.49273 -4.66259 -15.0904 10.7497 -285 2 14.2093 13.4501 8.17144 -24.2961 -0.252284 -5.87391 -286 1 14.9018 2.99422 15.3537 -18.6075 -8.06583 14.6174 -287 2 14.2375 2.30647 15.2045 2.81445 1.4476 3.5012 -288 2 15.4631 2.94521 14.5905 14.0528 3.89371 -13.7736 -289 1 9.86333 15.5824 16.9775 -1.70109 -0.0675876 9.27141 -290 2 10.3396 14.7637 16.7526 0.856458 3.65656 -1.57854 -291 2 9.55317 15.4797 17.8978 1.12056 -0.962034 -11.839 -292 1 11.2957 8.40029 16.577 -16.0633 -20.1101 7.86553 -293 2 10.6817 7.8482 16.0424 7.68237 12.4971 4.88138 -294 2 11.3251 7.92133 17.4322 4.78934 8.39937 -13.6138 -295 1 3.89281 18.1695 16.7848 -3.14598 -18.8551 -14.8366 -296 2 4.41813 17.5168 17.2844 -2.97968 13.5676 2.86087 -297 2 3.87713 0.360621 17.2331 6.32956 9.89438 13.0847 -298 1 2.18947 4.17934 8.91366 -18.0693 4.35017 -17.8699 -299 2 3.09766 4.08917 8.6846 23.1764 -2.78898 -7.58361 -300 2 2.16493 4.06394 9.84833 -5.05649 -4.17918 28.8808 -301 1 9.87375 10.372 9.69798 10.3489 -25.1121 17.1783 -302 2 9.47622 11.1704 9.40878 -10.9495 28.2307 -13.2887 -303 2 10.0218 10.4724 10.6474 2.61027 -3.39635 1.23761 -304 1 9.66501 0.904023 10.8717 -13.0386 -22.5074 -9.87351 -305 2 9.3051 0.0213231 11.0865 8.01248 8.88818 8.11202 -306 2 9.06191 1.19139 10.169 9.00305 9.82525 0.172013 -307 1 9.18563 15.0903 10.2115 17.1556 13.6164 1.72702 -308 2 8.73275 15.8289 9.78742 -0.477718 6.62954 -2.89772 -309 2 8.53792 14.3995 10.1946 -15.8858 -12.7719 2.13472 -310 1 0.946133 9.58267 10.2797 -17.999 7.07835 7.04569 -311 2 0.977457 10.4775 10.6382 -6.96742 -0.068666 -4.76802 -312 2 1.85682 9.38261 10.1843 21.4216 -13.3352 -8.00245 -313 1 16.9414 4.83421 8.13223 15.4014 12.0295 -27.8426 -314 2 16.4342 5.57084 8.44793 -11.0978 12.5109 2.31217 -315 2 16.8158 4.17203 8.77314 -2.49922 -25.6846 24.7871 -316 1 14.7535 14.7061 0.203986 15.073 4.98951 -2.11802 -317 2 15.1043 15.2916 0.890887 3.3452 -1.27018 2.88153 -318 2 13.9621 14.3164 0.552408 -18.4772 -7.94901 9.40987 -319 1 3.67958 11.0243 9.53991 2.98139 -0.929731 17.0732 -320 2 3.55398 11.294 10.4695 5.20942 3.18167 -4.3207 -321 2 3.23108 11.6955 9.00414 -3.72853 0.365488 -5.84942 -322 1 11.2021 10.759 1.44219 -17.3262 -13.0718 -7.65614 -323 2 11.58 11.5828 1.16251 10.55 19.7497 -9.01804 -324 2 10.309 10.7579 1.05212 6.07305 -2.69648 6.21388 -325 1 13.1662 7.17502 12.7531 25.9391 -3.29657 1.887 -326 2 14.1362 6.96154 12.7671 -19.0435 5.16748 0.470499 -327 2 12.7272 6.32599 12.8606 -4.03684 -6.30893 0.442018 -328 1 9.61497 1.86018 0.978015 -9.58691 9.0933 -29.7593 -329 2 8.82052 1.59363 0.443821 14.7013 3.9795 16.3864 -330 2 10.1598 2.41617 0.376969 -4.12787 -12.2318 8.97473 -331 1 10.6544 13.5231 4.58863 -13.6132 -6.73185 -2.44549 -332 2 11.4017 12.9559 4.77554 12.969 -5.04099 -4.5155 -333 2 10.624 14.0848 5.36102 -2.93668 8.13722 11.8558 -334 1 14.451 1.77042 10.9566 -5.06993 -21.3108 1.92478 -335 2 15.2282 1.34301 10.5576 -2.05514 6.77792 0.416034 -336 2 14.5487 2.7176 10.8324 3.84606 4.21375 0.609558 -337 1 14.5616 12.2019 11.6619 17.6804 1.81894 22.1071 -338 2 15.3038 12.427 11.1092 19.6924 5.46932 -2.69443 -339 2 13.8862 12.1117 11.0284 -35.3643 -9.54852 -21.0379 -340 1 8.20666 5.07147 9.84086 19.0973 -30.0877 -21.2342 -341 2 7.45963 5.1784 10.3955 -25.2729 10.7477 18.5337 -342 2 8.15765 4.10536 9.6198 7.47394 24.0469 -0.436218 -343 1 1.5637 16.9015 18.3956 -12.4387 -25.8837 12.5929 -344 2 2.10927 17.2609 17.7108 10.7809 10.3745 -20.1818 -345 2 1.47705 15.9462 18.1578 7.28008 19.3441 8.23831 -346 1 1.51254 17.2865 15.33 -55.1424 19.1245 13.5119 -347 2 1.44158 18.2256 15.6397 11.4216 -23.3977 -5.64032 -348 2 0.55797 16.9673 15.4072 37.0312 4.44622 -8.61518 -349 1 3.63692 5.75726 6.07961 7.7365 -18.3794 -8.43759 -350 2 3.1745 6.31944 6.69962 -9.61621 11.1355 4.40451 -351 2 4.08899 6.28836 5.40075 -0.121738 1.87808 9.22135 -352 1 12.4625 9.47055 14.2033 -9.88788 31.7301 7.89028 -353 2 12.9131 8.72585 13.8435 10.9703 -26.4307 -11.7769 -354 2 12.2412 9.2145 15.1039 -0.841012 -4.82452 5.58465 -355 1 4.05279 15.2823 6.91192 -35.0907 -10.5097 14.3913 -356 2 3.49702 16.0377 6.67476 5.8423 0.670453 -1.17602 -357 2 4.92638 15.5321 6.67665 32.7349 8.37925 -5.72993 -358 1 0.666426 8.62945 15.01 -4.81633 6.31993 2.8284 -359 2 0.390025 9.55783 15.0778 2.6081 -0.187855 1.05312 -360 2 1.36445 8.64555 14.3512 6.1817 -1.74341 -6.99991 -361 1 12.9834 8.27358 10.2916 -19.5051 6.59204 10.6567 -362 2 13.6375 7.73399 9.85191 12.7638 -5.94229 -3.5145 -363 2 12.8815 7.86968 11.1799 4.96282 8.38227 -11.7258 -364 1 15.3269 7.75333 3.56288 29.5219 38.2257 -22.8776 -365 2 14.5855 7.35684 3.13467 -21.9298 -17.371 4.59449 -366 2 15.5403 7.50003 4.45743 -10.8574 -16.6026 13.017 -367 1 17.2887 6.69393 0.021468 15.5778 -19.6292 8.74644 -368 2 16.7574 5.92192 0.248673 1.14134 -1.83764 1.32773 -369 2 16.6558 7.32534 18.3698 -22.9594 20.3863 -6.57681 -370 1 8.86981 6.94597 7.81474 24.2415 27.8548 -9.55577 -371 2 9.77577 7.36617 7.90295 -24.2622 -15.8521 -2.69303 -372 2 8.7837 6.29392 8.50186 -0.35036 -13.7271 19.3897 -373 1 12.3819 0.576227 1.23609 4.50683 -3.19553 -2.96149 -374 2 13.3476 0.534404 1.26268 -2.04299 5.45052 6.49319 -375 2 12.129 0.50298 0.316799 -1.00379 -2.5807 -2.54403 -376 1 5.62478 15.1294 14.5559 -8.95515 -20.8805 6.21096 -377 2 4.66749 15.251 14.733 11.0075 0.339747 -2.61971 -378 2 5.99586 15.9305 14.1948 2.79164 18.0184 -3.26028 -379 1 3.86891 6.41255 1.75203 -0.0773217 -5.81596 13.5476 -380 2 3.55695 7.28194 1.50076 -6.60469 12.2107 -8.14743 -381 2 4.09127 6.52195 2.68979 -0.816275 -1.80663 -6.76426 -382 1 3.9342 11.5843 12.3776 -18.6931 -4.72392 -0.912594 -383 2 4.79227 12.0122 12.4616 2.30575 0.246561 2.78418 -384 2 3.29871 12.1178 12.8946 9.72132 -5.51488 -9.32366 -385 1 5.32882 3.8676 15.8786 0.594801 -80.2026 -15.123 -386 2 6.00417 3.18473 15.5574 -21.0433 25.388 14.8589 -387 2 5.72544 4.69544 15.8213 26.1638 51.9163 -2.72297 -388 1 14.3304 10.2034 4.48175 -27.4096 24.8129 53.7077 -389 2 14.5884 9.79586 5.33863 -8.33179 4.59428 -12.4543 -390 2 14.8538 9.80174 3.84099 29.6706 -27.6476 -38.9945 -391 1 7.77951 17.4021 9.16969 8.83259 -7.31352 -4.45478 -392 2 6.90706 17.6601 9.4324 -15.0276 -0.0996042 12.8709 -393 2 7.95009 17.9588 8.40488 9.49987 1.3194 -6.72214 -394 1 4.51552 14.5162 3.99356 4.98181 -4.90212 -22.3913 -395 2 4.52626 15.4247 4.27156 -0.518589 17.7617 2.00307 -396 2 4.31207 14.0204 4.77138 -3.57212 -17.3619 18.7252 -397 1 14.1875 7.4375 15.7998 -22.901 -10.8896 -16.0938 -398 2 15.1146 7.35808 15.6286 24.9688 -1.25651 -4.60954 -399 2 14.1131 7.89225 16.6248 1.32628 8.65776 19.0596 -400 1 2.98527 18.3068 1.9119 -4.72699 -30.9822 -37.1172 -401 2 2.49826 17.7826 1.20191 12.7581 13.6458 27.4428 -402 2 2.34371 0.225349 2.32895 -15.9948 14.8465 9.72817 -403 1 8.01181 1.59883 4.56348 -29.7821 5.07108 -10.5683 -404 2 7.46781 2.03632 3.88017 -2.37558 -3.45248 10.775 -405 2 8.87859 1.65459 4.20584 24.9106 -1.40589 -4.13938 -406 1 2.43696 14.1424 17.6778 32.6678 8.55365 0.150748 -407 2 1.74447 13.6484 18.0869 -17.757 -15.5673 8.49591 -408 2 3.25626 13.7213 18.0204 -5.64692 6.54589 -2.94203 -409 1 0.856601 1.76819 13.8909 -34.0133 7.6587 12.0684 -410 2 0.79549 1.64555 14.8654 10.1884 -1.39389 -18.6264 -411 2 18.5699 1.97567 13.6249 24.5068 -3.80874 6.24474 -412 1 4.3972 0.0813689 13.9033 -13.8751 0.78744 16.7708 -413 2 5.2251 18.2898 13.7459 20.8939 -4.75733 -3.28132 -414 2 4.21678 18.5292 14.8441 -3.95615 2.50922 -10.6456 -415 1 7.163 0.723926 18.3524 28.8431 -20.8152 -22.3389 -416 2 7.29578 0.265373 17.4701 -6.89821 16.5948 25.8874 -417 2 6.28988 1.09447 18.4079 -18.4483 2.86302 0.00697782 -418 1 16.0461 18.4126 13.9592 23.9709 4.87143 24.0859 -419 2 15.127 18.3862 13.8391 -39.1169 -4.38354 -15.9017 -420 2 16.1011 18.5404 14.9193 8.5862 0.360016 -3.75437 -421 1 10.1416 4.5234 16.2814 33.6533 37.5162 -8.59515 -422 2 11.1148 4.69187 16.0483 -33.0569 -13.9639 15.4314 -423 2 9.96481 3.59397 16.253 2.9151 -23.0089 -4.34536 -424 1 15.9284 17.7644 4.42623 32.451 -11.9188 -9.4973 -425 2 16.5348 -0.134683 4.55752 -3.00893 1.73986 -2.0661 -426 2 15.0985 18.0471 4.75447 -36.3204 13.6328 11.8833 -427 1 7.01478 17.4412 13.8546 -37.2955 -8.85564 -21.6385 -428 2 7.52749 17.7553 14.5758 15.4879 9.12118 24.9138 -429 2 7.64547 17.2338 13.1683 11.7367 1.38126 -7.54157 -430 1 13.2517 6.48941 6.59541 21.6379 18.6409 -4.45059 -431 2 14.0732 7.02646 6.4901 -17.572 -15.5204 8.29538 -432 2 12.9904 6.33391 5.6816 -8.39128 -3.46546 0.217322 -433 1 7.82903 2.34082 9.30706 0.848413 1.46751 38.8479 -434 2 7.32489 2.17899 10.1397 9.78087 5.93227 -12.3925 -435 2 7.21411 2.12937 8.62642 -15.7826 -8.09866 -24.9258 -436 1 15.1931 14.7992 13.6996 5.60594 -14.9485 0.236255 -437 2 14.8724 15.0774 14.5533 -1.16755 2.2837 13.7936 -438 2 15.0044 15.5062 13.0994 -6.5851 10.7381 -11.5383 -439 1 9.39722 8.31385 3.80437 -4.07127 17.2834 -4.44624 -440 2 10.2713 8.68973 4.00761 -3.0526 -2.08627 -0.470344 -441 2 9.46128 7.36215 3.86627 5.27028 -8.92187 3.93672 -442 1 17.7859 13.5845 16.3834 -19.0466 -29.0207 18.2461 -443 2 16.8295 13.3731 16.3512 7.31415 3.8698 0.00611806 -444 2 17.8697 14.4051 15.917 1.12921 18.7325 -11.1152 -445 1 4.94376 10.5922 2.82245 -18.0715 22.8685 -14.9529 -446 2 5.66076 10.3167 3.37377 16.0421 -11.7082 13.1735 -447 2 4.72943 11.4907 3.12728 0.871258 -13.2337 -1.99455 -448 1 3.75648 8.36099 10.0882 -2.83158 17.8244 -9.78689 -449 2 3.88314 9.30809 9.8443 -3.15161 -16.2727 -0.870444 -450 2 3.74879 8.36585 11.0419 0.849549 -1.60464 13.0402 -451 1 15.9818 6.99244 6.07768 -13.3688 18.7296 1.03973 -452 2 16.7792 7.41732 6.38792 13.9106 3.61693 3.9934 -453 2 16.2026 6.08994 5.88298 6.53831 -20.9898 -2.75314 -454 1 15.1161 7.11481 9.04764 0.565665 -31.7989 38.5144 -455 2 15.8028 7.45918 9.62834 5.57768 4.61323 -0.34974 -456 2 15.1416 7.62578 8.27782 1.5606 28.4329 -39.6698 -457 1 6.26636 12.9592 12.746 15.2088 -10.2167 -2.30532 -458 2 7.09456 12.5046 12.9751 -5.12301 -5.10662 -0.512627 -459 2 6.13107 13.5604 13.4742 -6.25916 17.1748 9.55337 -460 1 12.1295 4.51914 13.098 -40.0586 -31.7334 -0.542355 -461 2 12.3128 4.55827 14.0372 7.66008 7.87672 6.17129 -462 2 11.3118 3.91999 13.0515 32.2373 26.2449 -7.62055 -463 1 11.3854 8.14886 7.92202 -18.4022 6.94815 -10.6415 -464 2 11.9487 7.53516 7.44565 12.5498 -6.92106 -4.31871 -465 2 11.7891 8.26504 8.77918 7.07043 -0.608458 13.7447 -466 1 17.1486 10.8722 7.52372 -29.3422 15.2924 19.4167 -467 2 17.741 10.1746 7.28593 21.144 -15.6164 -13.9006 -468 2 16.9754 11.4691 6.78151 4.60435 -5.53137 -7.06809 -469 1 5.26553 18.1239 10.9774 20.3802 -2.13667 -3.01104 -470 2 4.75345 17.8709 11.7323 -12.4512 -5.88679 12.7575 -471 2 4.64325 18.2391 10.2688 -13.5246 2.23536 -17.92 -472 1 7.60715 17.4884 1.7834 -2.49749 -8.82149 -34.1915 -473 2 7.92668 16.7242 1.2322 -11.5566 19.54 16.0619 -474 2 7.18999 18.106 1.13139 15.7932 -7.79309 14.6318 -475 1 1.92845 12.8983 13.5911 -4.1829 -6.61346 -8.43532 -476 2 1.49445 12.3761 14.2737 -4.42561 -3.96966 1.7572 -477 2 2.30088 13.6477 14.0465 3.83448 15.9215 12.3791 -478 1 9.57624 6.80131 14.8487 2.82943 -31.3701 -0.177857 -479 2 9.74438 5.86263 15.1368 -4.04832 25.5486 -0.431769 -480 2 9.80341 6.81631 13.907 0.113844 6.0265 -0.426062 -481 1 15.2789 4.31862 10.7553 12.937 12.8557 31.6205 -482 2 16.1415 3.96953 11.0436 -5.39931 0.983411 -21.2391 -483 2 15.1479 4.98349 11.4601 -8.5537 -3.88808 -14.9921 -484 1 11.2581 6.18474 0.159508 31.1076 25.8623 9.85053 -485 2 11.549 5.31982 18.5294 -8.46095 -20.0483 -6.31791 -486 2 10.3153 6.29854 0.132928 -17.8901 -6.88616 -7.00405 -487 1 -0.015613 11.3989 15.0155 5.52071 0.0143375 15.3818 -488 2 18.1286 11.6803 14.2478 -6.84029 3.18322 -8.47428 -489 2 -0.24984 12.0811 15.6717 7.42423 -4.02873 -7.86488 -490 1 7.04792 9.26093 7.28081 24.8295 12.5521 -3.74072 -491 2 6.59027 8.49663 7.6071 -13.7147 -18.0719 7.78469 -492 2 7.98742 9.01504 7.31689 -8.33941 1.9664 -1.88331 -493 1 18.3308 15.3469 12.3202 -6.03602 -2.26652 6.8961 -494 2 0.60478 15.4762 12.0772 12.6515 4.5696 -6.24084 -495 2 17.7927 15.7945 11.6538 0.941578 1.81095 -5.33876 -496 1 16.5149 4.38922 5.26132 -0.591505 19.7601 -54.4807 -497 2 16.8056 3.98806 6.0517 15.8153 -15.5532 32.6352 -498 2 17.2724 4.45951 4.61195 -16.46 -3.71476 24.2381 -499 1 17.705 3.15738 10.7395 -3.58994 -28.0349 -4.43916 -500 2 -0.0357658 3.31586 11.0143 13.799 7.93723 3.46651 -501 2 17.7252 2.25587 10.3433 -5.09014 14.337 3.42017 -502 1 12.282 -0.0102014 10.1171 1.80463 -26.6374 -6.99772 -503 2 11.3739 0.250254 10.2263 -16.4794 9.03176 6.86793 -504 2 12.791 0.759276 10.3145 17.2573 22.9944 3.87451 -505 1 10.3906 9.77529 12.4736 -11.6246 -18.6488 -11.2601 -506 2 11.1162 9.76462 13.0993 9.33947 3.77576 6.26492 -507 2 10.2448 8.81959 12.3007 0.540403 13.8663 1.27912 -508 1 0.620737 2.80838 7.04076 1.85552 -26.9198 -9.07562 -509 2 0.56001 3.58776 7.58035 -0.0658531 10.9425 14.6075 -510 2 1.10446 2.13014 7.5549 -9.15748 13.0523 1.42789 -511 1 0.330306 15.2957 6.90187 -7.34135 39.0889 57.248 -512 2 0.64916 14.9551 7.78023 -6.58887 6.78122 -17.5325 -513 2 0.549392 14.6745 6.26262 18.9985 -47.7984 -33.3782 -514 1 17.0475 6.9988 15.1595 3.61332 2.27156 3.35689 -515 2 17.7695 7.63103 15.0486 -1.58895 3.22527 -3.41358 -516 2 17.4554 6.32111 15.7084 -3.97121 -9.30147 -1.03946 -517 1 9.1229 12.4841 8.04245 42.4716 -17.0961 -6.2748 -518 2 9.3803 11.751 7.44403 8.89783 14.9312 6.88846 -519 2 8.20686 12.4452 7.97952 -55.5673 6.80073 1.54221 -520 1 1.25348 1.79037 2.92813 -6.45569 8.99744 5.64127 -521 2 0.618969 2.05555 2.26044 -0.811293 0.804254 -10.1384 -522 2 1.53437 2.62736 3.32834 8.32683 -8.65344 1.50874 -523 1 4.08283 15.132 9.84955 18.6585 -7.67887 -4.13383 -524 2 4.13303 15.3467 8.91064 -4.64689 1.73023 -5.13685 -525 2 4.95775 14.7288 10.0227 -10.2431 6.10486 1.39562 -526 1 7.30601 2.19422 14.6517 -6.95706 -8.0865 3.71032 -527 2 7.17746 1.61632 13.8834 -0.940722 6.01065 3.73041 -528 2 7.50104 3.06853 14.3169 9.18921 6.42869 -7.97623 -529 1 18.506 14.6308 2.17255 -30.1365 -0.614545 -1.61255 -530 2 0.727688 15.0378 2.26332 7.05 8.92743 1.17189 -531 2 17.7886 15.3173 2.20949 19.3309 -8.24877 -2.15246 -532 1 9.97566 2.72581 12.9114 -11.2099 12.673 12.9937 -533 2 9.86165 2.06107 12.2382 3.86591 -12.7401 -14.4562 -534 2 9.16654 3.26167 12.8314 9.11555 0.77907 4.27596 -535 1 2.93178 8.92582 13.081 1.70152 2.66119 1.53014 -536 2 3.14805 9.86555 12.9479 4.31652 -6.20308 -1.56758 -537 2 3.73073 8.51399 13.4597 -8.92719 0.122715 -5.32652 -538 1 3.2497 8.49808 3.73135 7.7637 26.6897 -66.399 -539 2 3.59457 9.35475 3.3251 -8.07179 -35.8245 7.88572 -540 2 3.32757 8.66083 4.63283 0.688531 4.50937 55.9505 -541 1 5.66796 7.21231 8.59238 -0.641232 -8.3741 -2.33168 -542 2 5.55885 6.25431 8.52804 10.6614 2.37054 -1.78385 -543 2 4.98671 7.4468 9.22816 0.961703 9.61661 1.51464 -544 1 14.8738 1.42122 1.93778 -12.939 -8.09002 14.9013 -545 2 14.5066 2.19936 2.41013 13.5309 -5.26917 -12.7438 -546 2 15.3961 1.64306 1.16722 2.80937 13.5796 -4.98575 -547 1 8.4154 15.1394 0.773463 -1.23857 3.93157 -9.75401 -548 2 9.15191 15.1483 1.39458 4.79594 -7.97678 6.77178 -549 2 7.72939 14.5584 1.13871 1.01453 -0.106788 3.48853 -550 1 15.5631 1.364 7.19799 20.5383 14.1474 18.9399 -551 2 14.9704 0.811359 6.72127 -20.082 -15.4085 -14.9718 -552 2 15.0111 2.04928 7.59859 -2.39038 6.78983 -5.63995 -553 1 5.04086 13.0229 18.4653 -16.526 -4.40388 -18.1368 -554 2 5.51186 13.0765 0.64315 8.46246 3.02378 17.117 -555 2 5.66208 13.3388 17.7987 -1.33855 -1.44241 4.73678 -556 1 15.3891 8.54048 18.1286 -6.10206 -9.0298 20.9903 -557 2 15.6702 9.06907 17.396 9.32842 15.5064 -17.6225 -558 2 15.3407 9.15597 0.239346 -3.25407 -2.5962 -5.00154 -559 1 12.0788 3.07289 18.3192 12.549 -10.6185 1.49283 -560 2 12.5729 2.60825 0.359083 -9.10594 9.02489 11.6275 -561 2 12.4194 2.60778 17.5512 -7.87867 2.96301 -9.52933 -562 1 13.1665 12.6793 5.14706 7.93439 -3.9476 12.1924 -563 2 13.7696 11.9755 4.86963 -4.91093 -2.83846 -5.3825 -564 2 13.2489 12.6724 6.11347 -1.2685 5.53825 -1.32442 -565 1 6.04116 7.20215 0.12064 7.04453 6.18255 -12.3628 -566 2 5.83851 8.12748 -0.154348 1.72696 -16.7644 14.2262 -567 2 5.20617 6.73813 0.252386 -0.898724 4.83199 2.26117 -568 1 17.6547 15.8889 14.9543 35.0528 -4.14946 21.8068 -569 2 16.7907 16.2722 15.0644 -14.9966 1.76464 -15.1201 -570 2 17.9353 15.7106 14.0428 -17.4402 7.26196 -6.43436 -571 1 13.1733 0.917277 16.6395 -12.3557 8.76343 2.76166 -572 2 14.0527 0.785776 16.9891 12.1183 -2.33791 -0.0845054 -573 2 12.8033 0.0287439 16.599 0.155899 -2.85039 -4.8341 -574 1 10.9713 14.5555 7.36537 -14.2255 -14.9035 9.86762 -575 2 10.1709 14.1495 7.79489 23.622 7.7433 -12.5051 -576 2 11.716 13.9517 7.54396 -5.74804 5.50666 -0.0050929 -577 1 17.5337 8.50243 2.08938 -5.40396 -31.7286 -5.54565 -578 2 16.6651 8.377 2.51924 11.1588 5.07358 -2.60802 -579 2 17.6234 7.66639 1.54889 -0.0314299 30.6214 9.39113 -580 1 12.3599 7.90174 1.98937 3.23567 -16.3128 -6.49447 -581 2 11.7961 8.65526 1.85661 -2.62113 17.411 2.96359 -582 2 12.056 7.28247 1.30894 3.22552 -0.339632 3.88847 -583 1 11.9987 14.6627 10.3756 12.942 21.9862 15.1728 -584 2 12.1481 13.8459 9.95801 9.02096 -31.6093 -18.7525 -585 2 11.0572 14.7574 10.3761 -24.4084 6.55121 -1.49817 -586 1 6.83545 6.97591 15.5496 -11.1581 -18.4558 -7.96595 -587 2 7.75433 6.91064 15.3306 20.697 -3.79434 -9.10488 -588 2 6.829 7.75126 16.0755 -7.29309 23.7102 19.2635 -589 1 8.01446 4.61093 13.3684 -42.1501 -10.3174 -21.1074 -590 2 7.18404 4.82769 12.8493 26.4504 -9.34552 12.0218 -591 2 8.34807 5.45326 13.6307 9.05324 16.4922 6.04122 -592 1 13.4266 12.1814 14.3212 -6.42777 -0.785601 -11.9683 -593 2 13.0158 11.3184 14.1828 2.17743 -6.12306 4.21948 -594 2 13.8675 12.3621 13.4761 -0.124998 4.48227 1.48561 -595 1 14.6825 9.43166 7.27492 9.85972 28.3832 27.9741 -596 2 15.5174 9.92891 7.46534 -14.0141 -13.1604 -8.13985 -597 2 14.0576 9.79435 7.94424 7.51867 -12.8522 -19.303 -598 1 12.7091 16.9592 3.18265 16.188 -54.3303 -7.24671 -599 2 12.7269 17.2341 4.07879 2.36138 14.6014 27.6129 -600 2 12.279 17.6213 2.6979 -21.2589 39.1636 -23.5451 -601 1 1.03636 7.13727 17.3765 4.75158 -4.20474 15.7377 -602 2 0.172257 7.41544 17.719 4.25282 -10.0113 -2.57097 -603 2 1.1139 7.5113 16.5007 -3.03142 8.85376 -8.54904 -604 1 12.882 5.00728 15.6915 -13.3168 2.35737 2.40623 -605 2 13.5933 4.38686 15.8029 14.6532 -13.0711 -0.480408 -606 2 13.3236 5.8608 15.7721 -0.35756 9.80313 -2.71263 -607 1 2.42233 3.36085 5.14652 -1.4819 -20.4954 -28.2661 -608 2 1.78479 3.2289 5.83557 -10.283 -5.3637 15.3955 -609 2 2.79623 4.21009 5.29825 15.429 26.5106 10.9541 -610 1 8.29403 11.1124 13.578 -10.7346 17.3121 -71.8204 -611 2 8.44225 10.8317 14.4188 2.94407 -17.9634 86.1576 -612 2 9.02074 10.6663 13.1421 6.44484 1.50589 -14.4967 -613 1 12.9406 1.47026 13.2897 0.354478 -37.8914 22.4103 -614 2 13.6523 1.40022 12.6671 11.2026 2.70228 -18.849 -615 2 12.6313 2.34545 13.2159 -11.96 35.388 -6.53093 -616 1 6.51021 13.5896 2.17003 14.8824 -7.80817 -21.2989 -617 2 5.87965 13.8406 2.83705 -10.6705 6.78718 16.3658 -618 2 7.14425 12.9838 2.58896 -6.69863 7.51381 1.45504 -619 1 15.9112 6.50963 12.6885 16.1371 8.47906 -9.98075 -620 2 16.4229 7.02402 12.0187 -10.4906 -13.771 14.0264 -621 2 16.4535 6.54884 13.5054 -11.4677 1.21509 -6.34034 -622 1 16.8027 0.705691 9.58115 1.1294 19.8318 -8.72086 -623 2 16.927 18.412 9.70296 -4.50862 -18.5326 4.35013 -624 2 16.4766 0.834017 8.66778 -1.09927 -3.21438 5.98018 -625 1 6.10776 11.6244 8.30817 -7.08025 31.3016 10.3571 -626 2 5.31117 11.3633 8.78813 -2.85933 -0.839224 -1.79107 -627 2 6.50869 10.8152 8.04097 10.2317 -24.1838 -9.43106 -628 1 2.82434 8.71866 0.367104 27.0695 8.27339 20.5452 -629 2 2.22535 8.20379 18.5266 -22.1964 -28.7808 -30.261 -630 2 2.24775 9.38106 0.731441 -2.19807 14.7641 10.188 -631 1 10.1092 10.4559 6.56308 -0.703462 -11.3062 5.02538 -632 2 10.4957 9.70218 7.03882 1.80116 3.11275 -0.176711 -633 2 10.5447 10.4553 5.70619 3.2422 0.610478 -8.25928 -634 1 6.77867 15.7679 6.62657 -1.68281 -11.8864 -9.65654 -635 2 7.19346 15.995 7.46341 4.74707 6.17504 0.549944 -636 2 7.26738 16.2069 5.90636 -4.84487 7.71134 8.89334 -637 1 6.4599 12.9833 5.69613 7.9309 12.6721 2.99822 -638 2 6.6611 13.9194 5.88765 -3.42976 -10.7335 1.27405 -639 2 6.10779 12.6203 6.51977 -0.735551 -2.83601 -1.42622 -640 1 16.7784 12.5316 9.7686 6.64513 16.9355 2.79564 -641 2 16.9553 11.9755 9.0112 -1.14761 -14.6768 -5.4217 -642 2 17.3143 13.3158 9.58219 -8.26404 -2.19889 6.01862 -643 1 6.14902 2.92407 2.76687 9.25618 8.55881 7.16487 -644 2 6.44579 3.84137 2.53376 -9.69316 -20.3131 -2.03165 -645 2 5.73381 2.47389 2.01355 1.00911 7.28801 -3.60537 -646 1 10.8507 3.14979 3.2526 -8.20022 -5.11042 -1.435 -647 2 10.2526 3.87795 3.44424 2.28516 4.24005 3.08111 -648 2 10.4324 2.67577 2.52169 3.50832 1.84172 1.62718 -ITEM: TIMESTEP -60 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.82699 6.8727 17.8888 7.11742 1.34647 0.262135 -2 2 7.99 7.13914 18.2565 -12.0864 4.19935 8.4109 -3 2 8.62901 6.07007 17.4227 -0.244169 -11.025 -10.1388 -4 1 18.7394 8.29949 6.7561 2.34576 -2.93089 -42.9257 -5 2 0.440553 7.9626 5.87052 -19.1153 18.5732 27.9896 -6 2 0.571955 7.78688 7.39134 9.59653 -12.4008 18.4821 -7 1 8.51178 18.783 6.87295 -6.05415 -5.58023 12.25 -8 2 9.39304 0.279078 6.53812 12.1519 1.3365 -4.9205 -9 2 7.9628 0.741428 6.37316 -1.87647 6.654 -3.74148 -10 1 6.53357 1.7197 11.6944 -32.7429 -8.61455 3.24653 -11 2 5.73579 2.18358 12.0739 27.4882 -10.0969 -10.5409 -12 2 6.18445 0.855878 11.3477 8.95005 26.2974 10.8481 -13 1 6.96535 5.62987 2.3961 35.6431 -32.0928 -15.0783 -14 2 6.38293 5.93218 3.05619 -24.6612 16.4463 30.6134 -15 2 6.84916 6.21974 1.66578 -5.97717 13.8881 -18.7681 -16 1 16.1974 10.2298 16.1222 0.837184 6.4903 1.28091 -17 2 17.0743 10.6189 16.0747 2.49014 -9.13099 -5.48379 -18 2 15.6463 11.0038 16.2733 -2.87215 -2.05097 1.79245 -19 1 10.6702 14.9469 2.31164 21.9083 12.0632 13.3283 -20 2 10.6818 14.2862 3.02723 -4.43621 6.7471 -1.73288 -21 2 11.263 15.6645 2.64965 -13.2726 -10.9824 -6.65814 -22 1 17.1701 8.22403 10.7142 -10.4028 1.03109 3.96163 -23 2 16.5672 8.79102 11.2349 7.05768 -1.94337 -2.70487 -24 2 17.9333 8.77716 10.499 4.44622 1.4788 -2.07857 -25 1 14.6797 15.9035 16.4693 -22.461 3.39408 -16.7947 -26 2 13.7484 16.2021 16.2951 24.3498 -9.2952 11.1 -27 2 14.6463 15.3225 17.2482 2.4047 10.3841 -3.14234 -28 1 12.1037 13.3669 0.54665 -3.27844 11.868 -6.89748 -29 2 11.8248 13.5865 18.2899 5.63772 -9.83511 -2.25753 -30 2 11.6388 14.0254 1.08354 0.310925 -7.08728 5.11983 -31 1 9.3344 5.48343 3.92748 33.8763 5.32583 -18.4372 -32 2 8.84687 5.22044 4.68611 -23.4915 -4.94858 24.7343 -33 2 8.7079 5.56619 3.20676 -14.265 -0.820383 -3.61874 -34 1 1.71101 4.06482 11.6122 14.6912 -29.1046 6.03323 -35 2 1.58258 4.96723 11.8918 -1.25551 20.6962 3.43651 -36 2 2.34968 3.65386 12.2459 -15.6865 7.58906 -11.285 -37 1 2.0576 6.82445 8.24528 12.7796 11.6573 13.2587 -38 2 2.61911 7.2356 8.94539 -14.081 -6.70064 -12.0447 -39 2 1.89349 5.9205 8.55263 1.83531 2.80349 -1.77694 -40 1 5.39864 4.45401 7.95786 1.68333 5.33174 7.59028 -41 2 5.55249 3.50745 7.87389 -3.64833 -7.88894 -5.24716 -42 2 4.83854 4.74959 7.2381 -8.525 -1.92619 -10.156 -43 1 3.30216 2.93412 17.4505 12.3495 -29.8256 -18.8762 -44 2 3.92727 3.3713 16.8479 -0.637689 -1.64749 6.41076 -45 2 2.89532 3.6118 17.959 -11.8167 26.1488 16.8317 -46 1 7.4312 5.4352 6.15055 3.3909 -0.433751 -53.1737 -47 2 7.92374 5.97877 6.73644 15.9967 14.3411 25.9486 -48 2 6.95714 4.77392 6.61797 -10.969 -14.5624 25.0012 -49 1 9.79304 6.98632 12.0044 -11.2776 3.50532 -30.3595 -50 2 10.3262 6.37648 11.4616 -6.26095 5.52929 9.55968 -51 2 9.10346 7.3395 11.3719 14.604 -9.64535 21.0978 -52 1 14.0819 3.68689 8.0984 5.37498 8.43639 24.1843 -53 2 13.9041 4.52495 7.65095 -1.63712 -2.30615 -0.914734 -54 2 14.2511 3.92795 9.04472 -1.39906 -3.736 -24.3353 -55 1 4.49163 17.2405 3.95076 10.4122 -13.5126 12.545 -56 2 5.41424 17.4498 3.85674 17.5711 4.37719 2.71306 -57 2 4.10795 17.4238 3.10711 -15.6864 12.0721 -17.6618 -58 1 16.4063 16.5742 10.3304 -30.4876 -1.09383 10.2792 -59 2 15.5552 16.587 10.8552 23.7267 -0.690427 -17.666 -60 2 16.1781 16.1401 9.48726 -2.06021 -0.342568 9.10707 -61 1 2.01216 4.81629 0.267482 -15.744 -7.33716 -25.0709 -62 2 2.32092 5.21812 1.07081 12.8803 9.20197 12.7852 -63 2 1.84588 5.54667 -0.35429 -3.07657 2.24499 6.46529 -64 1 11.4525 13.2643 16.3577 0.360612 25.402 13.2121 -65 2 11.0472 12.4174 16.5451 -7.76012 -9.6277 -2.94397 -66 2 11.9986 13.1376 15.5855 6.89063 -5.57893 -10.2697 -67 1 10.1527 10.9848 16.8633 -20.103 19.6526 2.73515 -68 2 10.5885 10.1542 16.8545 15.6291 -29.738 -2.50548 -69 2 9.22545 10.7635 16.7018 -0.592014 4.00252 0.856412 -70 1 11.7907 17.4531 13.47 6.77179 16.9038 -5.30963 -71 2 12.2429 16.8403 12.875 5.23267 3.61287 1.34276 -72 2 12.1771 18.3441 13.2664 -10.6628 -13.9509 7.62196 -73 1 6.44648 9.35189 12.2088 11.1766 16.4313 12.1054 -74 2 7.06476 9.1188 11.5034 -9.94127 -5.08631 1.40965 -75 2 6.99588 9.90362 12.7958 -7.62877 -4.94562 -4.27954 -76 1 16.2706 12.8594 2.68209 -1.75731 9.60563 4.91889 -77 2 17.1141 13.3556 2.57766 -16.4869 -7.21292 0.814827 -78 2 15.5397 13.5204 2.75856 19.4288 -8.85346 -2.79343 -79 1 0.706006 12.6575 5.91598 14.3848 1.31093 7.35726 -80 2 1.05127 12.3982 5.06653 10.4666 0.953953 -14.2919 -81 2 18.4268 12.7017 5.73438 -31.2224 -1.2993 2.30782 -82 1 5.26466 16.4058 18.4218 -16.1073 15.9927 3.08559 -83 2 5.67174 15.6665 17.9813 11.5666 -13.4602 -0.82172 -84 2 5.61268 16.4896 0.669718 7.09967 -3.66518 0.290508 -85 1 0.630514 7.71832 4.14439 -40.0144 -22.0429 16.8318 -86 2 18.6762 8.08291 3.48621 -5.56982 2.47832 -6.04635 -87 2 1.47362 7.93412 3.82987 48.6931 13.8203 -16.755 -88 1 3.15187 8.95984 6.48267 23.8542 8.38798 -14.0929 -89 2 3.71388 8.45844 7.06344 9.53544 -4.30832 6.22463 -90 2 2.31458 8.97258 6.8974 -32.9047 0.579586 11.7619 -91 1 7.26503 10.3427 16.2788 17.1997 0.0580756 -23.1821 -92 2 6.56569 10.7121 15.7432 -4.58149 2.66195 0.233626 -93 2 6.94547 10.3415 17.17 -9.40627 -4.59594 18.3856 -94 1 11.082 0.946861 5.00581 6.19269 9.74659 5.8053 -95 2 11.2852 1.82567 4.65658 -6.55006 -0.520752 -0.877191 -96 2 10.8571 0.430046 4.22808 -5.9868 -5.86677 -2.53499 -97 1 4.345 2.8292 13.2132 -1.27186 28.7368 -8.62995 -98 2 4.51529 3.21096 14.0791 1.17168 5.0352 0.572822 -99 2 4.2316 1.91147 13.3845 -6.13817 -32.6591 5.85186 -100 1 8.38376 10.2307 1.79685 4.09005 3.74222 -19.3624 -101 2 8.31491 10.9253 2.45197 -4.24337 3.92137 10.2746 -102 2 8.66929 9.45546 2.26885 2.27917 -12.8064 10.4703 -103 1 10.3305 1.70894 15.5022 6.01592 -1.55552 8.18831 -104 2 11.2875 1.57757 15.6324 -10.5356 -0.805047 -6.9053 -105 2 10.1546 1.87921 14.5629 5.4285 2.19916 1.25738 -106 1 2.65797 12.824 7.8537 2.67737 0.310449 -2.88199 -107 2 3.19441 13.4775 7.37699 -0.834696 -1.21778 5.43137 -108 2 1.94106 12.6113 7.24505 -1.36647 0.43678 -0.0339739 -109 1 3.78494 11.7026 5.05983 17.7759 13.7966 10.32 -110 2 3.63161 10.9725 5.64962 -3.29006 -9.81966 6.20688 -111 2 3.00915 11.823 4.52928 -13.3129 -0.91097 -10.8894 -112 1 6.77794 14.436 16.9596 -4.81268 9.99067 -5.99614 -113 2 7.54793 15.0018 17.1111 -0.926912 -4.93073 -4.17577 -114 2 6.38498 14.6674 16.0968 9.73202 -0.180074 3.30595 -115 1 14.2221 14.5157 3.27778 -13.9298 6.06594 9.9851 -116 2 13.8151 15.3779 3.06073 2.11094 -9.8452 8.88116 -117 2 13.8089 14.1856 4.11 4.80477 6.02161 -17.3229 -118 1 8.54544 18.1123 16.0497 -51.2002 16.193 -5.03192 -119 2 8.97127 17.2819 16.1484 30.3531 -21.0569 10.3371 -120 2 9.10378 0.243275 16.0887 21.8256 4.58901 -4.15396 -121 1 4.6724 1.65079 4.89395 -0.428695 -35.2982 26.3678 -122 2 3.9342 2.19791 5.10489 -21.2256 11.2309 2.3914 -123 2 5.17375 2.14476 4.28849 23.1392 22.1006 -30.0951 -124 1 14.9936 12.6291 16.4673 -19.77 11.4375 -24.1827 -125 2 14.4795 13.0601 17.1383 2.64859 2.32978 20.7439 -126 2 14.3496 12.6271 15.7247 18.4778 -8.83273 3.74622 -127 1 15.7172 18.4491 16.8771 -38.7365 1.31848 -37.9731 -128 2 16.4119 18.3751 17.4758 43.0193 1.36234 40.9307 -129 2 15.3332 17.5625 16.8778 1.44654 -2.1141 -5.88546 -130 1 1.31769 1.23679 16.6144 -6.54563 -5.62507 -9.64947 -131 2 2.12749 1.70533 16.7963 11.1847 9.69542 4.67012 -132 2 0.698368 1.60678 17.2434 -6.22801 1.29783 7.94738 -133 1 18.1828 4.42633 15.9571 -10.2445 4.38521 4.02875 -134 2 18.0727 3.95797 15.1342 -1.32851 -5.12675 -7.69371 -135 2 0.442412 4.30859 16.2307 9.57607 0.794437 2.0974 -136 1 12.2114 16.9885 16.1505 19.3184 14.9656 -43.0527 -137 2 11.4192 16.582 16.4369 -30.1172 -13.2398 21.5491 -138 2 12.0643 17.0779 15.1772 3.25614 1.68146 17.8786 -139 1 16.0795 2.58494 18.1555 11.3664 -10.2705 19.274 -140 2 15.8693 3.49863 18.3 -12.3112 17.2654 5.58069 -141 2 15.8977 2.41247 17.2454 -5.4363 -1.34473 -24.067 -142 1 6.67972 13.8354 10.1508 -8.25744 -4.72138 -13.3408 -143 2 6.54568 13.5231 11.0561 -0.87434 -6.75398 -1.82198 -144 2 6.44555 13.1152 9.51962 7.50297 7.52708 13.7797 -145 1 10.1393 18.4632 2.72581 -2.6903 -13.3312 7.25948 -146 2 10.3702 0.440572 2.04373 3.08075 7.1003 -10.4416 -147 2 9.34905 18.0295 2.38643 -2.95732 2.6687 3.95308 -148 1 3.05039 17.7207 6.12428 0.448774 -3.44066 -6.39261 -149 2 2.22716 17.4884 5.64326 9.1847 7.623 2.40325 -150 2 3.74061 17.8548 5.44564 -15.5509 -1.85687 4.81473 -151 1 12.5974 16.8374 7.98109 22.5462 3.91689 -18.138 -152 2 11.9813 16.1063 7.98041 -18.255 -3.99171 0.854341 -153 2 12.4106 17.4726 8.66951 -8.78709 2.06599 13.7307 -154 1 14.8906 15.2874 8.20197 12.2291 6.1037 -1.40009 -155 2 14.0169 15.6824 8.32954 6.14586 6.92547 -6.68196 -156 2 15.3058 15.6925 7.40177 -13.6896 -13.6819 15.1947 -157 1 17.774 18.2462 0.317021 16.5526 -0.292921 -8.65749 -158 2 18.517 17.6459 0.018512 -14.2865 26.6269 11.4024 -159 2 18.1212 0.514643 0.485201 -2.53379 -23.9559 -4.59837 -160 1 0.824062 10.4854 1.38532 29.0751 41.1299 -24.8426 -161 2 0.152225 9.85957 1.54468 -35.7643 -25.6114 8.77961 -162 2 0.463481 11.18 0.764874 10.1431 -20.9883 20.7352 -163 1 1.76832 12.2434 3.3342 -0.376699 -6.62105 -8.54196 -164 2 1.60728 11.5206 2.66813 -0.613387 21.7926 10.4725 -165 2 1.98383 13.0773 2.86566 -4.64348 -14.8628 -2.7215 -166 1 0.631416 17.2455 4.93339 -1.94983 -6.83399 6.66588 -167 2 18.8682 18.1422 4.98859 -2.83763 -23.6492 7.38562 -168 2 0.299607 16.5671 5.5918 8.11627 31.0276 -16.6779 -169 1 1.13057 0.905706 9.36586 -12.3827 -0.18715 22.5068 -170 2 1.31261 0.747855 10.3312 -4.25497 -2.51626 -23.3877 -171 2 0.268645 0.477115 9.21068 10.8181 5.54227 0.850191 -172 1 16.7346 2.37332 13.3038 3.72479 1.84576 21.5886 -173 2 16.9761 2.56684 12.4028 0.0757035 3.67621 -15.1405 -174 2 16.5678 1.42686 13.3713 -2.69734 -3.58003 -5.961 -175 1 2.71222 15.8556 12.0453 -23.2953 18.5694 10.7935 -176 2 3.02055 15.4773 12.8617 6.20357 -6.16654 7.20198 -177 2 3.26455 15.5565 11.3309 7.18341 -3.43964 -7.05157 -178 1 16.426 15.6488 6.1101 -14.7609 -25.4644 9.17481 -179 2 17.2826 15.6571 6.51544 16.1879 -4.44611 5.83009 -180 2 16.438 16.358 5.49538 -5.11113 23.225 -23.4349 -181 1 5.76882 5.13637 11.8122 -12.0704 17.5482 5.11471 -182 2 5.44081 5.9885 12.2003 4.95719 -19.5528 -5.70673 -183 2 5.01212 4.52871 11.8104 6.55972 2.89024 2.61392 -184 1 15.1343 4.86498 0.81249 17.6468 10.3526 -37.7608 -185 2 14.8624 4.60472 1.67155 -6.094 -8.43385 31.413 -186 2 14.42 5.38891 0.454388 -5.76674 3.16257 -0.979918 -187 1 16.354 16.4047 2.01729 -13.9507 10.6217 3.88258 -188 2 15.8491 16.8174 2.76015 19.926 -7.04016 -11.695 -189 2 16.7635 17.1307 1.5183 -3.64457 0.258913 2.52225 -190 1 0.229093 4.84171 3.85636 -16.5361 -39.1535 -9.01102 -191 2 0.280674 5.76384 3.97165 5.27146 43.6678 4.59383 -192 2 0.903367 4.46589 4.41298 10.8 -4.72049 2.86342 -193 1 2.98031 15.0696 15.1724 7.38994 17.2595 -26.1187 -194 2 2.78389 14.6733 16.0132 -4.59533 -4.91572 22.4357 -195 2 2.69496 16.0061 15.2442 -6.09825 -12.2809 0.399162 -196 1 1.14224 14.6486 9.53301 9.69931 -12.3423 3.57818 -197 2 2.08157 14.8372 9.66442 -5.69448 4.03807 -1.75917 -198 2 1.10168 13.6946 9.72739 -6.61933 10.5759 -2.74939 -199 1 13.5148 16.5367 11.5259 11.0739 -5.14125 9.92262 -200 2 13.0998 17.2443 11.0437 -3.0151 15.655 -8.61356 -201 2 13.0781 15.7617 11.1648 3.09342 -5.90037 -0.559148 -202 1 4.6468 1.4492 0.760442 21.9419 17.6404 -6.63386 -203 2 4.03376 2.00221 0.272437 -3.30289 2.18566 -6.21296 -204 2 4.11186 0.849122 1.26962 -7.6403 -10.762 3.4591 -205 1 1.46385 18.5705 11.8684 11.5971 1.37494 19.5738 -206 2 1.40443 0.572196 12.6059 -0.800227 -11.3118 -6.50307 -207 2 2.03902 17.8403 12.1929 -11.6325 11.1906 -9.16825 -208 1 11.4878 10.1514 4.00495 -23.562 -17.5625 40.225 -209 2 11.4445 10.4449 3.12053 -0.0273244 15.9845 -32.1431 -210 2 12.4087 10.0544 4.20335 22.0666 -0.101113 3.57488 -211 1 8.17978 12.1587 3.71493 28.653 -3.15285 -17.361 -212 2 9.01377 12.5671 3.97927 5.41625 0.887106 1.05136 -213 2 7.604 12.3558 4.43149 -23.5411 2.07968 29.6007 -214 1 14.5452 4.04195 3.30356 -17.0528 -5.31405 -8.64237 -215 2 15.1661 4.06926 4.02931 6.41379 4.8272 12.7333 -216 2 13.7233 4.44982 3.62226 2.87412 -0.159853 0.628569 -217 1 5.66111 1.64664 7.53337 47.3068 24.6854 -47.7691 -218 2 4.99385 1.2169 7.99076 -47.8059 -33.9417 34.4755 -219 2 5.55481 1.33937 6.59792 -2.0798 14.2024 17.8553 -220 1 17.8737 1.09537 4.84004 -13.6202 -14.1831 4.02096 -221 2 18.464 1.49436 4.20233 9.91759 7.15437 -5.32228 -222 2 17.8561 1.60546 5.65338 7.58498 6.35358 2.28946 -223 1 6.84561 9.39092 4.51119 3.77645 -4.79561 13.9854 -224 2 6.80242 9.62767 5.4641 3.30223 -6.77647 -16.668 -225 2 7.74702 9.0401 4.34673 -10.1352 5.61637 3.28246 -226 1 2.64818 14.8733 2.0031 -12.6643 -4.21043 8.13073 -227 2 3.39044 14.7832 2.61388 1.60205 1.10943 -1.58393 -228 2 2.93662 15.3311 1.21566 8.61024 -0.712779 -4.79925 -229 1 17.3356 12.9304 13.2091 0.397713 16.5012 -11.0143 -230 2 16.4513 13.2838 13.3976 5.15185 -2.46087 0.53778 -231 2 17.8465 13.7314 12.9621 -7.21788 -13.1567 2.02539 -232 1 14.9178 10.5628 1.45295 0.32879 33.5889 18.189 -233 2 15.3786 11.3985 1.79277 -12.1624 -32.8958 -12.3175 -234 2 13.9692 10.6935 1.62732 12.9477 -1.40805 -3.43718 -235 1 5.70482 6.69167 4.56094 -12.9541 28.0444 -8.31435 -236 2 5.76223 7.67071 4.46331 5.24004 -15.8993 1.97075 -237 2 6.3673 6.43877 5.21208 3.70858 -3.97365 0.601716 -238 1 7.97185 8.33683 10.3069 8.6941 -15.2025 -3.68424 -239 2 8.60404 8.92215 9.84221 -9.13329 -6.11086 -5.89913 -240 2 7.51742 7.70171 9.70626 6.59476 18.8917 -0.227694 -241 1 13.4177 18.464 5.71198 21.9916 6.6123 -14.6219 -242 2 12.6947 0.421284 5.51228 -9.11836 -2.12279 2.23123 -243 2 13.1839 18.0173 6.51737 -9.90438 -14.4062 13.6987 -244 1 0.0221035 2.62655 0.261444 12.6472 -47.1951 11.8456 -245 2 17.7527 2.75577 18.6598 -10.3686 10.7513 -7.61459 -246 2 0.546882 3.40438 0.188377 7.87852 33.0005 -3.15527 -247 1 12.8067 10.9927 9.75832 44.9647 -24.4125 8.46131 -248 2 11.8751 10.9314 9.65932 -31.4773 -7.30673 -3.09024 -249 2 13.1121 10.0761 10.034 -17.0663 24.2241 -8.13324 -250 1 0.673563 12.1459 11.0385 -14.9158 10.2345 17.3916 -251 2 18.3756 12.1565 11.2954 6.68564 0.0119082 -11.299 -252 2 1.10384 12.3853 11.8646 9.18612 4.40652 0.693569 -253 1 5.14721 7.33361 13.3929 15.7357 3.63047 1.84442 -254 2 5.59488 8.13358 13.0475 0.482915 -12.4288 -2.35902 -255 2 5.71887 7.03407 14.1269 -8.93121 6.52874 -3.37327 -256 1 1.18567 6.84505 11.8697 14.6786 34.5125 12.17 -257 2 0.393465 7.21987 11.4553 4.74321 -4.21777 2.31791 -258 2 1.70022 7.64215 12.2222 -16.972 -31.3024 -13.5319 -259 1 15.4816 9.69158 12.3277 9.90347 -39.8653 -1.57959 -260 2 15.3406 10.5924 12.1653 -13.2531 41.4735 -11.5871 -261 2 15.406 9.62533 13.2698 1.46249 -6.23285 16.1579 -262 1 16.5413 12.6347 5.5059 7.75274 -6.4804 14.118 -263 2 16.3104 13.5445 5.70094 -2.97213 12.2972 0.10227 -264 2 16.3923 12.5258 4.56955 -2.98329 -0.0504447 -18.3871 -265 1 6.30461 9.82716 0.0624729 6.72618 23.4574 16.6882 -266 2 5.51437 10.3287 0.304315 -0.069722 -0.440899 2.51054 -267 2 6.96842 10.0501 0.765687 -11.6212 -9.0506 -14.676 -268 1 12.2588 6.10042 4.03099 15.0483 24.7381 -3.94445 -269 2 12.3021 6.98896 3.58767 -5.34003 -28.327 1.95056 -270 2 11.3325 5.86569 4.06669 -11.2394 -4.89225 -2.88949 -271 1 0.336489 12.822 0.136131 -4.0328 -4.68121 -1.73262 -272 2 -0.0692718 13.3776 0.815875 4.64589 5.49593 0.971726 -273 2 18.45 12.9344 17.9884 -7.92492 5.13291 -5.47118 -274 1 3.58866 18.6351 8.62238 -6.65617 9.61834 5.79691 -275 2 3.41901 18.3768 7.70859 0.297411 -7.32139 -0.213682 -276 2 2.71275 0.31261 8.92207 15.7588 -5.16119 -5.17535 -277 1 7.50496 17.418 4.49772 -12.5742 -28.6928 8.65377 -278 2 7.55283 18.3491 4.58726 6.16277 33.1384 2.27358 -279 2 7.74423 17.2559 3.59134 -1.33953 -2.22923 -11.883 -280 1 9.26392 17.1331 12.2129 -23.7136 4.99112 -6.35848 -281 2 9.34774 16.2465 11.866 0.0093118 -9.2577 -7.50778 -282 2 9.98892 17.2487 12.8038 23.7327 3.38143 15.862 -283 1 13.3751 13.0337 7.97577 10.7478 10.6887 -13.5108 -284 2 13.3787 12.2298 8.50206 6.89696 -2.46192 7.10708 -285 2 14.2592 13.4885 8.01338 -22.4634 -9.00878 7.77512 -286 1 14.8592 2.99547 15.3735 -5.27851 1.66435 23.9116 -287 2 14.1885 2.32373 15.2402 -1.63897 -5.65445 -5.41614 -288 2 15.4149 3.00295 14.6023 9.16888 -1.78425 -15.607 -289 1 9.86925 15.6154 16.9672 4.33331 -1.89849 4.26663 -290 2 10.4152 14.8537 16.7052 -6.80597 -3.90746 -0.277805 -291 2 9.57771 15.4416 17.8827 0.419377 0.378738 -9.64067 -292 1 11.2678 8.44973 16.5939 -8.08747 -14.0791 2.0813 -293 2 10.6693 7.85604 16.0792 7.94549 12.4538 10.9378 -294 2 11.4172 8.01973 17.4598 -1.80582 0.647834 -14.6449 -295 1 3.91551 18.1683 16.8005 9.39931 12.2215 14.3903 -296 2 4.49606 17.6509 17.3756 -3.52447 -10.1131 -6.81095 -297 2 3.95318 0.38369 17.2365 -5.94998 0.470214 -7.14863 -298 1 2.19966 4.20574 8.91394 -16.952 6.25086 -28.7566 -299 2 3.11163 4.1112 8.67966 19.1354 -3.54458 -0.459765 -300 2 2.10589 3.95692 9.81579 -0.00585893 -3.49833 31.5267 -301 1 9.86514 10.3731 9.72031 15.6542 -41.5135 2.74879 -302 2 9.61489 11.2182 9.40808 -14.4527 35.546 -8.7168 -303 2 10.0569 10.3888 10.6595 -0.965326 6.48855 10.4451 -304 1 9.65603 0.92083 10.8651 15.4128 -5.93628 -1.69563 -305 2 9.35399 0.0448876 11.1808 -6.92756 10.8331 -8.061 -306 2 9.08478 1.27687 10.159 0.925367 -10.2687 5.27886 -307 1 9.17601 15.08 10.2001 28.4704 15.1584 7.58672 -308 2 8.86011 15.9493 9.94215 -4.94078 5.46469 -8.90142 -309 2 8.40516 14.5378 10.1682 -22.1716 -15.7686 -1.61012 -310 1 0.908908 9.65777 10.2661 1.02783 -39.6886 -13.0526 -311 2 0.968686 10.5462 10.5861 7.37828 17.5094 1.10535 -312 2 1.79128 9.34954 9.98968 -11.6106 9.29057 7.26807 -313 1 16.9796 4.82858 8.10785 29.2892 -10.1291 -25.9715 -314 2 16.4029 5.49318 8.42182 -23.755 22.5857 11.698 -315 2 16.8784 4.07707 8.6652 -3.89501 -13.8815 13.5617 -316 1 14.7893 14.6979 0.173135 5.39554 -7.96858 -12.7144 -317 2 15.0505 15.3823 0.785417 9.36392 5.93735 12.263 -318 2 13.9789 14.3219 0.494521 -15.109 -8.03615 11.244 -319 1 3.74323 11.0124 9.54886 4.38849 -4.14114 10.1409 -320 2 3.63158 11.395 10.4392 1.27308 -1.67175 -3.21468 -321 2 3.24423 11.5652 8.93525 -2.74645 9.31742 -2.2917 -322 1 11.2573 10.7534 1.46897 -2.74628 -20.4518 -2.00657 -323 2 11.6064 11.5358 1.05536 3.45865 20.4344 -8.16659 -324 2 10.3358 10.6724 1.18755 -1.77969 3.26872 -0.743535 -325 1 13.1779 7.19199 12.7182 14.2184 -9.05364 3.75753 -326 2 14.115 6.87295 12.7816 -17.4164 8.42328 -3.38551 -327 2 12.6212 6.40428 12.8017 3.66516 -2.90974 1.8722 -328 1 9.6094 1.86333 0.961036 -1.66559 10.1622 -20.0065 -329 2 8.74982 1.7634 0.476399 21.9169 -1.84649 8.18396 -330 2 10.2659 2.29351 0.366445 -15.6421 -6.48907 5.12748 -331 1 10.6591 13.4925 4.58018 -19.1141 -0.630091 -16.1529 -332 2 11.5305 13.1262 4.70232 12.5696 -8.82773 5.21944 -333 2 10.586 14.1761 5.24203 -0.728557 4.94256 14.6221 -334 1 14.495 1.73909 10.9749 -8.14936 -7.82556 -5.33359 -335 2 15.2253 1.30703 10.5146 2.44721 2.03735 2.44955 -336 2 14.6402 2.68373 10.8341 0.821335 1.15578 7.11863 -337 1 14.5247 12.1307 11.6327 6.29346 4.76638 51.459 -338 2 15.3146 12.4097 11.1999 18.4985 9.73575 -23.8815 -339 2 13.8662 11.9319 10.9987 -20.1843 -8.01501 -29.1382 -340 1 8.1934 5.08514 9.85848 20.6286 -7.50881 -18.2265 -341 2 7.39102 5.12991 10.3666 -14.5844 -3.05188 8.40055 -342 2 8.26178 4.1705 9.49849 -5.86813 14.6103 10.9415 -343 1 1.56363 16.9354 18.4208 -1.17306 -23.9048 5.52961 -344 2 2.13897 17.2639 17.7268 3.56106 5.06395 -9.30964 -345 2 1.54669 15.9596 18.2963 3.84009 16.9778 0.440392 -346 1 1.49268 17.3196 15.3241 -27.5122 8.95969 8.58328 -347 2 1.46041 18.2525 15.6844 -4.86102 -31.3543 -7.55486 -348 2 0.570896 16.9106 15.346 29.8648 20.9529 0.539048 -349 1 3.59911 5.78915 6.06648 9.03859 -15.9659 -5.84137 -350 2 3.1214 6.40715 6.60976 -11.746 7.94276 10.4286 -351 2 4.15987 6.31414 5.47841 1.03618 -2.86439 -0.897012 -352 1 12.5136 9.4824 14.2234 -14.5482 39.9006 11.9441 -353 2 12.9252 8.74241 13.842 20.5687 -36.5434 -22.703 -354 2 12.2915 9.17254 15.1019 -4.72781 -1.84288 9.93497 -355 1 4.05984 15.2792 6.9471 -25.1121 -18.1042 13.4141 -356 2 3.54373 16.0393 6.6659 -0.213909 7.77754 -0.115815 -357 2 4.94872 15.4739 6.70425 29.3053 8.29501 -4.075 -358 1 0.70733 8.67925 15.049 -6.53077 -6.52645 2.33041 -359 2 0.403057 9.59211 15.0995 2.0449 7.24241 -1.44461 -360 2 1.39578 8.67212 14.3782 6.73055 2.7204 -4.7895 -361 1 12.9505 8.27543 10.2426 2.52256 -9.36522 19.2887 -362 2 13.7222 7.81068 9.89429 1.56507 0.683648 -5.24915 -363 2 12.8789 7.88642 11.1491 -0.00217653 14.5673 -16.6218 -364 1 15.3477 7.80216 3.55401 -12.532 5.83489 -12.7989 -365 2 14.4906 7.48222 3.33103 -16.8871 -2.65253 -29.4538 -366 2 15.2947 7.61797 4.46883 25.5814 -3.41235 36.6493 -367 1 17.266 6.70187 0.000674068 12.1195 -8.95496 8.26487 -368 2 16.7457 6.00049 0.395257 -2.87342 -9.15243 0.336143 -369 2 16.622 7.35704 18.4101 -17.4752 15.3525 -8.08793 -370 1 8.88335 6.95399 7.81342 26.8473 24.5973 -5.8387 -371 2 9.80542 7.33522 7.87938 -25.1058 -10.3372 -2.45861 -372 2 8.7714 6.40725 8.58367 -2.11125 -14.3958 16.4377 -373 1 12.3879 0.548843 1.24082 4.42765 -0.472301 -1.45686 -374 2 13.3265 0.730859 1.40339 -2.38609 2.78881 -0.689397 -375 2 12.2563 0.636326 0.292606 2.56041 -5.4085 -0.678049 -376 1 5.63248 15.1125 14.5468 -9.48886 -16.8407 5.02155 -377 2 4.69503 15.2624 14.7723 5.83199 -5.28539 -1.87026 -378 2 5.99589 15.9615 14.314 8.44734 16.7096 -6.42729 -379 1 3.85575 6.39433 1.75493 1.50274 -8.79363 8.51258 -380 2 3.48975 7.20754 1.41538 -8.87879 17.021 -2.96274 -381 2 4.03803 6.55873 2.69128 -1.36395 1.28851 -4.88856 -382 1 3.93631 11.5299 12.3893 -8.10483 -0.317118 -5.66906 -383 2 4.80663 11.9435 12.4577 -3.51298 -1.2689 0.972005 -384 2 3.32279 12.1457 12.8171 1.30391 -5.08042 -1.13556 -385 1 5.30379 3.85961 15.861 3.26535 -66.7729 -21.4105 -386 2 5.99128 3.21668 15.5051 -18.0074 17.9789 14.3955 -387 2 5.71814 4.68422 15.8683 22.7973 48.3912 1.26107 -388 1 14.279 10.1761 4.52146 -28.2637 29.6843 37.5781 -389 2 14.4726 9.82647 5.40905 -2.50301 -0.0307068 -4.88302 -390 2 14.7482 9.65242 3.92054 26.3189 -27.9191 -30.9088 -391 1 7.73542 17.3919 9.15036 20.9187 -26.1564 3.32362 -392 2 6.89787 17.6412 9.51878 -14.391 11.6651 3.78997 -393 2 7.98556 17.9488 8.40931 -4.18052 11.5531 -5.69175 -394 1 4.50439 14.5239 3.99264 11.0977 -23.3764 -48.4991 -395 2 4.56306 15.4325 4.20277 -1.38797 35.5351 15.6514 -396 2 4.31322 14.0314 4.76491 -6.35847 -16.1784 30.998 -397 1 14.1606 7.45193 15.811 -24.1382 -9.56247 -10.586 -398 2 15.0553 7.36431 15.524 24.9604 -3.00047 -8.7167 -399 2 14.2305 7.91189 16.6334 1.28104 8.01927 19.5585 -400 1 2.99693 18.3516 1.90386 -17.8633 -43.3253 -26.4279 -401 2 2.47403 17.7132 1.31624 19.6124 26.5697 18.0429 -402 2 2.33007 0.205152 2.36966 -11.145 11.7012 10.1025 -403 1 8.00896 1.59538 4.54643 -14.6935 -3.1209 6.18761 -404 2 7.42733 1.99671 3.8763 8.34922 -0.442348 -1.34208 -405 2 8.90764 1.54031 4.21745 2.64121 3.0498 -7.75206 -406 1 2.41984 14.15 17.6911 38.7391 17.8224 -8.42313 -407 2 1.65201 13.6768 17.9262 -26.9962 -21.4224 14.4939 -408 2 3.15619 13.6354 18.0755 -0.305296 5.75785 -2.4818 -409 1 0.881322 1.80893 13.8899 -12.9164 4.63859 7.1799 -410 2 0.998981 1.67187 14.8549 -5.47541 -0.367675 -15.7697 -411 2 18.568 1.96442 13.7158 18.7475 -1.65173 8.16576 -412 1 4.35626 0.108756 13.8915 -10.9503 4.16473 7.68997 -413 2 5.20313 18.36 13.6952 15.0207 -4.30703 2.98167 -414 2 4.18562 18.5651 14.8318 -0.53115 -1.77986 -5.89667 -415 1 7.21985 0.783193 18.3638 -3.94277 -6.88163 -25.1551 -416 2 7.12969 0.383485 17.4575 9.77138 9.98351 24.3944 -417 2 6.41237 1.28912 18.5059 -6.03182 -4.67978 5.08395 -418 1 15.9996 18.4041 13.9383 18.1315 -1.4443 -10.5581 -419 2 15.071 18.4425 13.7445 -14.3326 2.53282 3.85714 -420 2 16.1651 18.6473 14.8506 -8.9044 -3.87569 12.2679 -421 1 10.1939 4.54115 16.2821 35.3159 -4.68875 2.87762 -422 2 11.1919 4.40884 16.3129 -34.2522 14.5881 -3.55905 -423 2 9.86192 3.67371 16.0442 -3.43039 -7.24249 -0.81883 -424 1 15.9323 17.7355 4.44233 22.6638 -20.6434 -12.8847 -425 2 16.5412 -0.18272 4.5755 6.4476 10.7336 -1.45992 -426 2 15.0915 18.0468 4.70328 -34.4096 13.9436 14.4512 -427 1 6.99117 17.4686 13.8836 -42.0334 -7.7574 -17.1448 -428 2 7.47631 17.7428 14.6303 20.6357 14.1189 34.523 -429 2 7.65356 17.3815 13.215 15.8945 -3.28854 -19.4769 -430 1 13.2291 6.49408 6.5607 17.0277 2.09005 0.593761 -431 2 14.1816 6.76782 6.52286 -25.3304 -6.60509 -4.73803 -432 2 12.9166 6.35235 5.64754 5.89534 0.461784 7.57918 -433 1 7.85324 2.32148 9.35275 5.46391 6.9162 26.9577 -434 2 7.3686 2.17076 10.1976 2.69269 5.61176 -14.2633 -435 2 7.26481 2.08775 8.6472 -14.0957 -9.57593 -14.6111 -436 1 15.2023 14.7793 13.7187 7.74208 -16.2001 -4.59991 -437 2 14.8319 14.9596 14.5759 -4.08925 6.59301 14.3355 -438 2 15.0747 15.5488 13.1771 -7.6118 10.0658 -7.58078 -439 1 9.41047 8.32341 3.83123 -6.47708 13.1987 -5.34522 -440 2 10.2452 8.80483 3.85219 3.73168 3.01968 4.76716 -441 2 9.63137 7.40393 3.95808 -1.29777 -11.5098 0.542939 -442 1 17.7649 13.5922 16.3898 -11.4367 -25.6902 16.7919 -443 2 16.7908 13.5407 16.3666 6.32242 -2.67761 -0.626712 -444 2 17.9873 14.3645 15.8914 0.275374 22.0623 -11.5119 -445 1 4.92213 10.5724 2.8597 -4.83644 2.51404 -15.3254 -446 2 5.59736 10.2151 3.4378 8.5726 -2.027 3.49443 -447 2 4.66951 11.4171 3.23999 1.02108 -1.77966 3.70944 -448 1 3.74742 8.38157 10.0278 -2.2319 9.94706 -11.0912 -449 2 3.89489 9.30484 9.7273 -4.74563 -10.9217 8.16333 -450 2 3.84233 8.40088 10.9831 -0.997449 0.744123 6.62097 -451 1 15.9666 6.96875 6.01253 -14.8276 15.8227 3.08109 -452 2 16.7817 7.37259 6.30064 12.9112 7.94175 5.43996 -453 2 16.2196 6.12219 5.66656 5.41287 -21.5059 -0.527712 -454 1 15.1391 7.15478 9.02923 3.95319 -30.3017 38.192 -455 2 15.9165 7.52141 9.44882 9.73374 3.98045 10.059 -456 2 15.0698 7.60427 8.22918 -5.81948 28.1077 -46.3627 -457 1 6.22822 12.9188 12.7298 1.31868 -8.19268 -13.1839 -458 2 6.88351 12.2656 13.01 8.10485 3.82836 6.8834 -459 2 6.11855 13.5785 13.4162 1.19396 9.04898 12.3458 -460 1 12.1253 4.52441 13.1066 -23.5121 -14.293 -11.093 -461 2 12.4631 4.60406 14.0095 -9.44452 -2.69015 3.06865 -462 2 11.2831 3.97256 13.0795 31.8956 18.265 6.80246 -463 1 11.4055 8.12657 7.94639 -16.7563 2.96014 -17.3287 -464 2 11.9383 7.50834 7.43372 10.7385 -1.00284 -0.366803 -465 2 11.8652 8.24712 8.77366 5.83315 -1.26494 14.2429 -466 1 17.1037 10.8819 7.56719 -22.1575 4.54299 3.0458 -467 2 17.7705 10.2842 7.28531 25.0286 -24.4015 -2.83309 -468 2 16.8908 11.3655 6.76798 -3.05919 12.9941 -4.73253 -469 1 5.25302 18.1256 10.9232 26.818 -0.191878 -4.18594 -470 2 4.8269 17.8089 11.6994 -14.1597 -10.1429 18.6642 -471 2 4.64144 17.9747 10.2197 -19.8227 3.49229 -23.3423 -472 1 7.59833 17.4619 1.74995 8.37542 2.1771 -36.4257 -473 2 8.02215 16.748 1.21035 -16.0406 12.4022 13.5887 -474 2 7.374 18.1677 1.08602 7.01745 -13.9463 17.8331 -475 1 1.92633 12.907 13.6044 0.0880561 -5.46821 -16.7511 -476 2 1.47807 12.3822 14.2652 -4.39349 -7.86198 7.054 -477 2 2.32754 13.632 14.072 3.07665 17.0427 10.8635 -478 1 9.50987 6.80039 14.836 2.18935 -20.8269 12.8739 -479 2 9.79082 5.96037 15.3114 -4.54962 20.4196 -21.9392 -480 2 9.66995 6.7436 13.8735 6.47407 0.337666 8.03802 -481 1 15.2827 4.32341 10.7768 10.307 9.68599 -4.89646 -482 2 16.2397 4.0919 10.6916 -21.0983 9.39835 9.69703 -483 2 15.2266 5.10894 11.3663 5.46907 -15.4805 -5.79884 -484 1 11.3016 6.20596 0.140794 12.6043 6.09542 0.747046 -485 2 11.4786 5.29078 18.6344 12.8703 -22.3778 -2.75052 -486 2 10.381 6.25156 -0.0726873 -21.1699 14.4442 -0.985902 -487 1 -0.0715916 11.4097 14.9721 22.1692 -7.15633 35.3796 -488 2 18.1992 11.7732 14.1947 -21.0416 8.6568 -29.4322 -489 2 -0.201181 12.1402 15.5966 -0.594523 -4.50066 0.166015 -490 1 7.04588 9.27411 7.30476 9.145 16.929 -11.701 -491 2 6.64583 8.45304 7.57308 -6.76023 -15.305 10.0219 -492 2 7.98749 9.10222 7.20319 2.10913 -2.81405 2.65036 -493 1 18.3255 15.3308 12.2943 -10.9271 3.22482 1.76971 -494 2 0.551901 15.6023 12.004 16.2571 0.370549 -2.10144 -495 2 17.7334 15.6802 11.6169 -1.97195 2.58378 -3.71708 -496 1 16.5011 4.39937 5.27673 4.48444 11.2976 -56.5136 -497 2 16.7777 3.84422 5.96849 7.0389 -19.8316 37.8082 -498 2 17.2036 4.29545 4.59204 -6.79319 11.0559 14.2779 -499 1 17.7009 3.16012 10.7623 -11.0785 -13.2259 -8.21854 -500 2 -0.0365931 3.41438 10.9472 14.4195 -1.11458 2.04579 -501 2 17.6933 2.32175 10.2562 4.60522 6.17753 6.57508 -502 1 12.2846 -0.0106908 10.1146 7.09195 -37.1879 -10.2172 -503 2 11.3926 0.256016 10.2673 -25.9358 14.4274 7.98014 -504 2 12.8288 0.732071 10.298 19.2326 28.445 5.65892 -505 1 10.3866 9.75519 12.5017 -6.95633 -10.4248 -20.8372 -506 2 11.1983 9.82383 13.0055 7.4239 -2.70171 9.41801 -507 2 10.3064 8.80301 12.2683 1.05955 14.1529 10.144 -508 1 0.648708 2.774 7.07027 -1.36725 -4.55963 12.8723 -509 2 0.490272 3.61188 7.51443 -2.95105 4.17746 -2.75047 -510 2 1.10621 2.25999 7.75495 -4.79333 -3.92365 -3.87978 -511 1 0.307244 15.292 6.87913 -0.83379 49.2439 44.5727 -512 2 0.652444 15.3347 7.80405 -9.58611 -2.1659 -14.8737 -513 2 0.567348 14.4512 6.61032 15.5663 -52.8882 -22.8213 -514 1 17.056 6.99125 15.1184 -7.99596 0.858836 -4.56633 -515 2 17.7814 7.62276 14.9808 0.742784 -5.19204 3.90514 -516 2 17.4035 6.24942 15.6288 5.94943 -0.679765 0.413052 -517 1 9.13726 12.4999 8.01885 37.0353 0.885775 16.8739 -518 2 9.52568 11.8572 7.39973 -10.6447 2.68521 -0.695331 -519 2 8.21726 12.5875 7.87097 -30.0746 -3.81245 -10.8301 -520 1 1.21553 1.74407 2.88052 -2.59699 -2.39415 1.38589 -521 2 0.835324 2.14494 2.08419 1.70776 2.79001 2.24225 -522 2 1.71989 2.41102 3.3678 0.071784 1.92406 -2.09937 -523 1 4.07628 15.1457 9.88397 17.4433 -7.82557 -1.54586 -524 2 4.111 15.2412 8.92029 0.253189 0.655179 -3.36934 -525 2 4.94389 14.7737 10.148 -8.68797 4.30724 -10.2942 -526 1 7.35101 2.21809 14.6867 -7.35168 5.20952 -5.71558 -527 2 7.12719 1.57839 13.9999 0.606569 0.313122 2.88765 -528 2 7.62455 3.00796 14.1978 2.82745 -2.40467 5.3071 -529 1 18.457 14.6023 2.16488 -22.5257 23.4253 1.52633 -530 2 0.650438 15.0238 2.37846 9.31401 -4.06208 0.652559 -531 2 17.8015 15.3468 2.21006 9.59865 -20.266 -2.54542 -532 1 9.9778 2.69966 12.9163 0.655502 16.6224 11.2027 -533 2 9.96654 2.13525 12.1425 -5.01566 -7.38072 -9.38582 -534 2 9.27217 3.36428 12.8011 2.98946 -10.098 -0.342741 -535 1 2.95791 8.92102 13.0894 10.3197 8.62466 2.37945 -536 2 3.25022 9.8484 12.9226 -2.55555 -16.3803 0.657875 -537 2 3.7553 8.44758 13.4136 -17.8894 4.38499 -5.11642 -538 1 3.26012 8.5452 3.75851 7.68136 4.64814 -61.3797 -539 2 3.65213 9.34274 3.2957 -8.84339 -23.8918 18.3111 -540 2 3.19772 8.72964 4.66662 3.169 13.2307 40.2657 -541 1 5.70723 7.22602 8.61089 15.0471 5.15238 -9.7988 -542 2 5.61347 6.27934 8.4361 -3.3163 0.301479 7.52532 -543 2 4.97449 7.5436 9.15453 0.52499 -8.4302 1.10573 -544 1 14.8706 1.4621 1.8863 1.70998 27.5213 20.9307 -545 2 14.7201 2.23316 2.46749 -8.28585 -15.753 -0.675778 -546 2 15.5631 1.82311 1.33978 3.90729 -10.8233 -20.0391 -547 1 8.4891 15.095 0.746196 -1.67248 3.44686 2.60315 -548 2 9.16152 15.1411 1.43932 5.44244 -6.16758 -2.29782 -549 2 7.78914 14.5375 1.12422 -1.25934 1.00196 -2.01266 -550 1 15.531 1.37665 7.20033 20.0832 14.6351 13.3031 -551 2 14.8916 0.843079 6.76136 -18.4007 -14.9103 -14.8508 -552 2 15.066 2.19014 7.43626 -3.82192 3.26637 1.54172 -553 1 5.03616 12.9919 18.445 -16.5564 -3.92778 -1.34985 -554 2 5.49952 13.0651 0.633359 3.65082 -0.909975 11.8673 -555 2 5.58799 13.4788 17.838 5.35286 -1.67587 -4.32886 -556 1 15.4004 8.57696 18.1096 -13.5133 -17.3986 23.7812 -557 2 15.6963 9.177 17.4428 12.1428 17.8023 -17.443 -558 2 15.2132 9.11981 0.25138 2.83515 1.87454 -5.46736 -559 1 12.0742 3.0873 18.3015 -13.0771 12.9456 1.32203 -560 2 12.4416 2.71193 0.467697 5.19488 -4.15516 -6.31478 -561 2 12.3414 2.59119 17.5164 7.34103 -8.20972 9.84797 -562 1 13.1603 12.6784 5.14975 4.6094 5.88635 0.276196 -563 2 13.6665 11.971 4.72065 -1.49243 -3.38503 8.68718 -564 2 13.2851 12.6103 6.1136 1.29016 -0.295852 -5.09341 -565 1 6.06548 7.22062 0.130395 -10.0215 14.1887 -9.78073 -566 2 5.90478 8.1622 -0.126677 10.3505 -23.4507 13.8616 -567 2 5.20282 6.91875 0.452817 7.86884 -4.47391 0.318594 -568 1 17.6551 15.8705 14.9463 -5.31761 6.83655 -25.2986 -569 2 16.721 16.066 14.8837 -6.35164 3.20497 21.4179 -570 2 17.8286 15.8261 13.9944 18.3936 -6.902 3.79502 -571 1 13.1598 0.895115 16.6829 -10.2787 13.0231 -1.21317 -572 2 14.0985 0.838925 16.8484 11.7714 -2.60716 3.82434 -573 2 12.9094 -0.0108285 16.49 -7.09766 -5.67505 2.02872 -574 1 10.9245 14.5193 7.39494 -10.4099 -10.8827 23.6465 -575 2 10.1209 14.2503 7.91799 23.546 5.98273 -19.3945 -576 2 11.6246 13.8906 7.65805 -5.45953 8.29317 -8.96944 -577 1 17.5666 8.45977 2.1077 -2.45541 -18.4017 -7.84499 -578 2 16.6916 8.4078 2.54921 14.2221 -0.924117 -8.74119 -579 2 17.6058 7.68446 1.4828 -2.53767 24.5137 15.8214 -580 1 12.3693 7.85876 1.99742 11.9287 1.39128 11.652 -581 2 11.9574 8.70597 1.81668 -2.84663 4.1279 -5.57453 -582 2 12.0661 7.22941 1.33154 -5.87406 3.00715 -1.1515 -583 1 12.0244 14.6632 10.3909 28.0505 -1.98221 6.53788 -584 2 12.2154 13.9026 9.84664 0.841551 -5.23881 -6.52272 -585 2 11.0973 14.8027 10.3697 -37.2752 0.615569 -5.61626 -586 1 6.83101 6.95959 15.54 -26.922 -25.3261 -7.84618 -587 2 7.74646 6.93869 15.3131 28.0025 5.72032 -4.23149 -588 2 6.70706 7.70294 16.1074 0.47288 18.1258 13.2198 -589 1 7.99181 4.56873 13.323 -17.7662 10.8645 -2.94772 -590 2 7.11502 4.75523 12.8947 23.3848 -2.11675 2.9311 -591 2 8.34221 5.42155 13.6369 -8.03699 -10.5621 -3.57795 -592 1 13.4097 12.1854 14.3195 -5.65215 6.28756 1.83858 -593 2 13.0403 11.2921 14.2436 5.24433 -3.00833 -1.58816 -594 2 13.8498 12.3732 13.4771 -2.55607 -2.02901 -2.35573 -595 1 14.6454 9.43305 7.28195 10.7596 15.6461 6.41649 -596 2 15.5174 9.89596 7.36949 -20.7431 -7.51972 6.68313 -597 2 14.0059 9.84843 7.89782 12.5114 -5.65293 -10.9965 -598 1 12.693 16.9181 3.21868 4.13721 -47.3842 -7.97708 -599 2 12.7878 17.338 4.04875 4.47204 15.8163 32.4195 -600 2 12.4838 17.5994 2.61833 -10.0532 31.8516 -27.8744 -601 1 1.00841 7.13021 17.3596 12.9632 -6.47488 11.204 -602 2 0.140567 7.22584 17.7618 -2.41623 -7.13214 2.78808 -603 2 0.956632 7.61621 16.5408 -0.0488819 7.87685 -11.8994 -604 1 12.917 4.94058 15.6965 -33.9833 6.00302 -1.61153 -605 2 13.6432 4.4005 15.9475 28.608 -13.7192 2.54357 -606 2 13.1955 5.85458 15.7909 9.71851 9.87704 0.635703 -607 1 2.3887 3.3689 5.15584 14.955 -15.9692 -52.0278 -608 2 1.80093 3.08916 5.81858 -25.593 -10.9876 33.4797 -609 2 2.79381 4.15677 5.46164 14.8077 31.4017 13.6729 -610 1 8.27435 11.0395 13.6153 -37.0795 23.6732 -65.6931 -611 2 8.36475 10.9269 14.5167 14.9976 -12.7369 63.1872 -612 2 9.08207 10.7919 13.1709 13.5323 -11.5041 2.55762 -613 1 12.9711 1.50053 13.2758 -7.16838 -21.0368 21.1096 -614 2 13.525 1.50324 12.5105 16.6349 2.94139 -20.1138 -615 2 12.6114 2.3778 13.3258 -6.20414 13.0805 -2.33086 -616 1 6.55993 13.5741 2.17335 4.5265 3.63418 -23.4358 -617 2 5.93511 13.8533 2.83279 -12.7543 7.85744 13.7798 -618 2 7.20659 13.0527 2.65116 1.25385 -4.10852 0.808212 -619 1 15.8831 6.47501 12.6409 22.0814 4.72601 -0.603906 -620 2 16.4738 6.98335 12.028 -14.2245 -11.2946 14.6347 -621 2 16.3705 6.43226 13.5009 -10.5632 5.96191 -15.5708 -622 1 16.8031 0.705923 9.56407 -2.28595 11.5891 -8.26827 -623 2 16.6552 18.4511 9.84906 2.3526 -17.7501 5.98934 -624 2 16.3731 0.773302 8.69375 1.62838 3.03603 0.698224 -625 1 6.10625 11.6157 8.28914 -3.08711 55.9701 7.34602 -626 2 5.36711 11.2964 8.79127 -16.3164 -7.54559 6.80515 -627 2 6.5283 10.8686 7.94164 19.8706 -42.6353 -12.8098 -628 1 2.81358 8.70539 0.376179 36.8039 -5.08598 16.3747 -629 2 2.33554 8.23944 18.3571 -22.6922 -9.90678 -17.9478 -630 2 2.28148 9.42572 0.700092 -14.5476 7.98537 3.82577 -631 1 10.114 10.4289 6.56839 -5.48816 -6.21666 7.2072 -632 2 10.5648 9.70982 7.03635 1.99723 -0.0329781 -1.13968 -633 2 10.3487 10.347 5.64237 7.8387 0.67993 -6.97128 -634 1 6.81211 15.7679 6.65103 -0.348958 5.58939 -1.23617 -635 2 7.12762 16.1335 7.48534 -0.336507 -3.46393 3.99871 -636 2 7.12562 16.4168 5.9986 -1.75978 -6.48118 -4.29666 -637 1 6.49059 12.9347 5.74014 0.722488 11.3509 6.39713 -638 2 6.52544 13.8593 6.05125 4.61742 -7.45139 -3.43251 -639 2 6.13117 12.4341 6.48422 -0.637044 1.07223 -0.836688 -640 1 16.7722 12.5296 9.75372 -10.3378 8.80589 22.9139 -641 2 16.9709 11.8837 9.07779 5.41942 -3.21474 -11.15 -642 2 17.3199 13.309 9.62307 0.866334 -2.28521 -6.10033 -643 1 6.18734 2.89369 2.76381 6.70118 21.5641 -20.0406 -644 2 6.53969 3.77128 2.46465 -8.05809 -16.0544 14.4298 -645 2 5.6766 2.59589 1.99155 1.09601 -8.68373 7.94101 -646 1 10.8178 3.09588 3.24672 1.33393 -8.05069 0.148042 -647 2 10.2056 3.80475 3.46561 0.323029 3.07521 -1.63087 -648 2 10.3998 2.55919 2.55618 -0.935454 8.00813 2.52947 -ITEM: TIMESTEP -70 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.83052 6.78564 17.8747 4.81039 14.7119 7.93216 -2 2 8.02044 7.08583 18.306 -2.95347 -6.04078 -1.17349 -3 2 8.57794 6.09723 17.2713 -4.49598 -11.7014 -7.63976 -4 1 0.124161 8.31212 6.74558 -2.09679 -1.27724 -21.4903 -5 2 0.320991 8.02726 5.80661 -3.30063 7.0305 29.7013 -6 2 0.593986 7.72695 7.35611 1.84479 -1.64007 -4.64643 -7 1 8.55341 0.214487 6.89794 4.20955 -4.60902 11.3327 -8 2 9.45965 0.255338 6.58274 3.95615 -0.229119 -0.443755 -9 2 8.09377 0.850204 6.35793 -6.3823 8.35705 -5.64785 -10 1 6.52177 1.69631 11.7106 -29.0447 -4.52087 -3.66773 -11 2 5.85029 2.25877 12.1616 13.2184 -10.2105 -7.98022 -12 2 6.00884 0.936302 11.3174 15.6542 21.0994 14.986 -13 1 6.92822 5.5902 2.37948 23.4336 -17.8876 -5.1013 -14 2 6.5261 5.8779 3.18071 -18.514 8.45901 19.042 -15 2 6.74676 6.28055 1.75003 -1.36947 6.04298 -15.8103 -16 1 16.1916 10.2374 16.1412 -24.0328 -6.0953 4.14694 -17 2 17.0138 10.497 15.7581 19.6671 8.99174 -7.62884 -18 2 15.6617 11.0456 16.2513 11.6446 -5.87426 0.419849 -19 1 10.7179 14.9528 2.30402 9.26606 5.76352 20.4147 -20 2 10.604 14.349 3.06349 2.85769 5.88214 -5.84145 -21 2 11.1755 15.7297 2.69585 -5.79349 -8.7688 -7.8832 -22 1 17.1683 8.21322 10.7989 1.82063 -1.23871 -1.95171 -23 2 16.5117 8.80699 11.1832 -0.385781 3.51193 7.00123 -24 2 17.9642 8.75858 10.6912 0.976865 0.382705 -5.65698 -25 1 14.6466 15.9322 16.4418 -21.6809 -6.01765 9.50279 -26 2 13.7097 16.2329 16.4085 18.6708 -4.64396 -3.84163 -27 2 14.6751 15.3815 17.2568 4.92661 10.5457 -14.6576 -28 1 12.1005 13.348 0.567693 14.0677 -11.0124 3.49805 -29 2 11.7977 13.4785 18.3054 -3.25303 6.53047 -2.60123 -30 2 11.7369 14.0166 1.16546 -7.92056 -0.136763 -7.41856 -31 1 9.34615 5.48792 3.88275 21.7787 0.248377 2.40385 -32 2 8.84331 5.37966 4.67443 -9.14 -4.08483 27.4632 -33 2 8.65688 5.52523 3.23949 -14.702 1.76912 -26.3373 -34 1 1.6606 4.00652 11.6035 4.04251 -10.384 -6.17332 -35 2 1.67583 4.94617 11.8049 -2.44143 11.0832 5.72027 -36 2 2.2695 3.55993 12.2146 -3.92557 1.72629 -0.38872 -37 1 2.08139 6.85853 8.20375 5.25116 9.81515 7.60897 -38 2 2.56831 7.24635 8.96213 -7.90159 -5.93168 -10.5698 -39 2 2.00199 5.91426 8.39105 -0.650687 0.0621593 5.33933 -40 1 5.36768 4.45674 7.91405 -3.32795 5.87339 3.17518 -41 2 5.46396 3.51228 8.0104 5.66802 -14.4695 -1.12836 -42 2 4.78412 4.56623 7.16078 -4.98903 9.02084 -4.56071 -43 1 3.31193 2.91026 17.4243 5.25503 -22.5991 -0.535021 -44 2 3.97925 3.43469 16.9765 8.2555 0.833912 -8.18173 -45 2 2.82292 3.51814 17.9594 -9.74498 21.4045 11.9966 -46 1 7.44628 5.47686 6.16962 4.83779 4.18627 -38.8589 -47 2 7.80337 6.02378 6.84422 19.7966 19.2933 17.1246 -48 2 7.08839 4.74785 6.63594 -15.5951 -22.4752 14.0992 -49 1 9.79841 6.99298 12.0115 -14.4173 0.175621 -19.7413 -50 2 10.2338 6.25953 11.5352 -7.27244 10.6531 4.67439 -51 2 9.07403 7.33711 11.4082 20.5779 -11.7539 16.8314 -52 1 14.0932 3.73018 8.11294 -2.35225 21.206 2.79521 -53 2 13.7164 4.53948 7.70027 6.06412 -15.1972 7.35067 -54 2 14.2932 3.96864 9.04107 -1.96145 -2.4542 -11.4015 -55 1 4.4865 17.2305 3.91995 2.87421 -17.2964 21.8602 -56 2 5.37817 17.5632 3.85852 13.1015 6.2627 -4.15101 -57 2 4.01126 17.4425 3.12603 -6.70645 13.3364 -16.7923 -58 1 16.3503 16.556 10.4027 -28.8153 -10.9362 -6.11544 -59 2 15.5262 16.5238 10.94 14.5825 4.08322 -8.19499 -60 2 16.0782 16.1167 9.56389 6.69544 5.4961 14.7824 -61 1 2.00781 4.81695 0.19428 -16.7794 -3.94444 -13.379 -62 2 2.36068 5.21925 0.976813 15.1603 4.4174 16.1734 -63 2 1.77343 5.5764 18.2905 0.379182 1.41768 -5.2961 -64 1 11.3582 13.2716 16.3898 -3.93488 16.8957 9.12151 -65 2 10.9039 12.4355 16.5285 -2.10099 -6.82713 -1.65452 -66 2 11.9323 13.1324 15.638 7.04428 -4.38588 -8.74921 -67 1 10.1365 10.938 16.8467 -2.82235 24.3376 4.32555 -68 2 10.5718 10.0987 16.7812 6.05632 -17.4389 0.305733 -69 2 9.20542 10.7786 16.7086 -10.6888 -4.42603 -1.21793 -70 1 11.8139 17.4685 13.4625 16.8497 6.47801 1.45884 -71 2 12.3399 16.8066 12.9857 -2.09189 7.12722 0.625626 -72 2 12.305 18.316 13.3535 -13.8327 -6.90215 0.736174 -73 1 6.44924 9.38958 12.2401 6.69888 0.367183 -15.9058 -74 2 7.02028 9.14259 11.4734 -10.412 6.11649 20.9521 -75 2 7.00474 9.9221 12.8226 3.16796 0.0903621 -0.913647 -76 1 16.2861 12.8631 2.69282 -5.5095 27.1919 6.93721 -77 2 17.1297 13.3403 2.5399 -11.4064 -12.6315 1.20497 -78 2 15.6248 13.5969 2.82884 15.7371 -22.5818 -6.03687 -79 1 0.705842 12.6958 5.89372 11.1118 0.602373 24.8353 -80 2 1.18521 12.4959 5.09265 -4.47491 1.87676 -19.0631 -81 2 18.418 12.5564 5.72922 -11.8137 -1.703 -8.70405 -82 1 5.28198 16.3804 18.4185 -2.246 1.3069 9.83982 -83 2 5.62966 15.5825 18.0261 2.19299 -6.30074 -9.03385 -84 2 5.78103 16.4802 0.590407 -0.738213 6.24336 1.72583 -85 1 0.669378 7.71651 4.13384 -59.2278 -40.1014 26.2385 -86 2 0.0696389 8.03317 3.4616 -5.2936 5.59306 -12.1338 -87 2 1.48105 8.07531 3.93226 66.8664 27.2164 -22.0097 -88 1 3.17848 8.98449 6.48797 -11.6429 31.0556 -28.5774 -89 2 3.69754 8.52221 7.10624 17.5545 -20.4274 28.0681 -90 2 2.28321 9.06095 6.81713 -8.12873 -6.01142 5.66961 -91 1 7.27057 10.3561 16.259 12.8547 -0.986094 -7.05958 -92 2 6.52139 10.8488 15.9387 -6.88577 4.52419 -2.25862 -93 2 7.07809 10.1849 17.1799 -5.89204 -3.21212 7.89434 -94 1 11.0493 0.926342 5.00492 7.6282 -0.312775 10.2028 -95 2 11.2745 1.78939 4.63491 -8.49938 0.0964505 -4.50291 -96 2 10.791 0.378052 4.25157 -0.730025 2.38059 -0.222793 -97 1 4.31171 2.85627 13.1955 -2.92819 26.6809 -11.7177 -98 2 4.37585 3.38692 13.9969 4.42074 -3.40265 4.05123 -99 2 4.21422 1.95476 13.4751 -3.58996 -22.8444 6.9477 -100 1 8.4068 10.257 1.78795 4.04191 -13.9705 -5.37842 -101 2 8.26785 10.8775 2.49552 -4.14797 15.7472 11.4003 -102 2 8.5529 9.42866 2.25521 3.43453 -4.46737 -1.06154 -103 1 10.2803 1.70096 15.4762 8.76071 -4.61575 -1.32446 -104 2 11.1657 1.41822 15.7142 3.10462 2.167 2.36838 -105 2 10.3075 1.82832 14.5156 -8.33356 3.27592 2.91474 -106 1 2.63173 12.8085 7.89063 4.0959 -9.21484 -0.859497 -107 2 3.2295 13.3973 7.41028 -2.49756 4.22571 1.84267 -108 2 1.98308 12.5062 7.24287 -1.99659 4.67741 -0.497136 -109 1 3.82895 11.7184 5.01628 -2.65331 8.28036 11.6201 -110 2 3.66291 11.1157 5.74556 0.426771 -3.98214 -1.1075 -111 2 3.01542 11.7805 4.50368 -0.128738 -0.0731644 -2.81963 -112 1 6.76514 14.4734 16.965 3.61018 3.02569 -11.8589 -113 2 7.44445 15.1431 17.0872 4.2046 -3.50831 2.36163 -114 2 6.5725 14.4959 16.0119 -5.95898 4.08629 6.49151 -115 1 14.2172 14.5156 3.23512 -15.7654 4.80027 20.0484 -116 2 13.9157 15.4376 3.23841 -0.320177 -6.15912 -4.56224 -117 2 13.7912 14.1249 4.0321 9.04818 0.126488 -15.8424 -118 1 8.62194 18.1001 16.0659 -23.21 2.71751 -2.03066 -119 2 9.16623 17.3958 16.3546 8.59431 -35.107 8.94544 -120 2 9.24682 0.159724 16.0687 7.59352 33.2076 -10.3682 -121 1 4.64785 1.66473 4.88429 20.0976 -32.3539 12.8345 -122 2 3.91841 2.23972 4.98678 -27.2909 21.6553 1.42112 -123 2 5.29938 2.12424 4.3745 8.75708 11.4615 -15.3566 -124 1 14.996 12.6195 16.4803 11.4842 8.30008 2.93566 -125 2 14.5677 12.8295 17.3315 -5.03395 -0.949445 -14.8823 -126 2 14.3989 12.5973 15.7101 -8.95177 1.91572 10.2236 -127 1 15.728 18.434 16.8656 -21.8007 21.3443 -35.9839 -128 2 16.2692 18.4514 17.6234 28.2096 -0.560819 33.2727 -129 2 15.2446 17.617 16.9069 0.184765 -20.6285 -2.2654 -130 1 1.36479 1.27889 16.6468 -16.7944 -10.044 -5.49533 -131 2 2.14801 1.79564 16.8219 8.14362 6.44014 2.70449 -132 2 0.693336 1.65446 17.2331 2.17778 -0.49248 0.882874 -133 1 18.205 4.38071 15.9717 -12.5383 1.08179 -4.34425 -134 2 17.9247 3.87865 15.1967 2.33887 0.121173 2.56773 -135 2 0.514445 4.3883 15.9876 8.17504 0.178033 -1.34417 -136 1 12.1632 17.0104 16.1415 17.8243 8.47052 -8.26904 -137 2 11.4339 16.4838 16.4748 -11.8796 -0.396392 0.7857 -138 2 12.1013 17.0682 15.1696 -12.6199 -2.93135 7.53111 -139 1 16.1201 2.6287 18.1864 3.80406 -3.99791 19.9987 -140 2 15.7935 3.50022 18.4009 -8.69312 10.1277 7.25942 -141 2 15.8264 2.47036 17.3057 -5.74882 -3.05042 -27.5508 -142 1 6.63908 13.8237 10.1059 1.54133 -19.2408 -0.896874 -143 2 6.60488 13.4547 10.9999 -2.4531 4.12781 1.41157 -144 2 6.6237 13.027 9.53669 -1.978 12.9815 -0.0933135 -145 1 10.1367 18.5192 2.71126 14.9692 1.08893 5.4249 -146 2 10.5375 0.290475 1.93143 -3.72697 -2.23961 5.76435 -147 2 9.31873 18.1319 2.42821 -14.2623 -5.70844 -7.57952 -148 1 3.05388 17.7183 6.14163 -17.3097 -9.85118 -22.5426 -149 2 2.24205 17.5791 5.58071 14.4512 3.50974 23.581 -150 2 3.73807 17.7208 5.46344 2.0394 5.03095 2.09251 -151 1 12.6118 16.8054 7.95495 4.58219 1.15158 -10.9791 -152 2 11.8555 16.2225 7.90842 -7.26482 -13.9478 -6.78863 -153 2 12.3849 17.4156 8.64585 -0.135632 15.5831 16.1371 -154 1 14.8975 15.2817 8.22586 -10.0433 25.2404 1.15436 -155 2 14.1016 15.8482 8.35876 13.2826 -12.9576 -5.35538 -156 2 15.2902 15.6258 7.39629 -1.79461 -13.1873 12.9757 -157 1 17.8242 18.245 0.290753 35.0262 5.69882 -22.3559 -158 2 18.562 17.7688 18.4584 -26.5201 3.44978 21.3008 -159 2 18.2553 0.461923 0.458274 -15.0979 -6.94564 5.00195 -160 1 0.811942 10.4929 1.40956 8.77271 16.3938 -17.0751 -161 2 0.0922351 9.87336 1.50209 -12.9574 -8.99075 8.33498 -162 2 0.506251 11.1761 0.770938 6.09002 -9.92994 11.4815 -163 1 1.80057 12.2567 3.3157 -0.00821892 -5.58838 -28.0373 -164 2 1.51905 11.5718 2.65287 2.57103 10.7079 19.8708 -165 2 2.13035 12.9839 2.7472 -5.7627 -4.92842 11.1942 -166 1 0.668516 17.2609 4.94683 -35.85 3.98858 25.1078 -167 2 0.0697466 18.0029 5.19004 17.5579 -5.46754 -17.9658 -168 2 0.309089 16.5456 5.51301 20.6369 3.3795 -13.3957 -169 1 1.1258 0.902495 9.33726 -12.4564 -3.06084 39.8122 -170 2 1.2842 0.722879 10.3134 -2.51149 4.27857 -26.5162 -171 2 0.280567 0.461704 9.18062 1.78742 1.97705 -4.09399 -172 1 16.751 2.38387 13.3212 3.93571 18.018 2.1702 -173 2 16.8889 2.64612 12.3995 3.13812 2.89192 3.07637 -174 2 16.5572 1.45381 13.2916 -4.67688 -18.3777 2.25645 -175 1 2.721 15.8932 12.0356 -10.4038 6.64935 25.1991 -176 2 2.99704 15.5189 12.8835 -2.56405 3.43208 -4.36032 -177 2 3.3254 15.553 11.3859 5.26998 -2.53603 -11.8474 -178 1 16.4132 15.6174 6.13158 -30.6236 -31.2218 7.18947 -179 2 17.2889 15.5331 6.46785 25.936 1.45578 4.51193 -180 2 16.388 16.3213 5.51027 2.55474 24.6255 -21.834 -181 1 5.75165 5.17156 11.8076 -10.0158 20.8309 8.83951 -182 2 5.58328 6.03799 12.2608 0.394348 -20.1746 -10.5178 -183 2 4.95414 4.6515 11.9927 8.5068 -2.87995 -2.26002 -184 1 15.1308 4.87532 0.804768 27.2949 -1.75024 -19.8676 -185 2 14.8777 4.72649 1.70618 -7.53991 -8.08598 20.9925 -186 2 14.4372 5.36761 0.397065 -18.333 11.5318 -5.57633 -187 1 16.3608 16.424 1.96087 0.545069 28.5814 -7.81874 -188 2 15.9402 16.8572 2.72963 9.40909 -7.94755 -2.88814 -189 2 16.7928 17.1706 1.4719 -7.75465 -17.4072 6.82817 -190 1 0.195497 4.8427 3.9016 -20.8114 -16.3238 -7.36148 -191 2 0.347935 5.77048 3.88737 2.90582 31.823 0.953261 -192 2 1.01225 4.48793 4.21241 18.9183 -15.2676 9.08502 -193 1 2.99687 15.0761 15.1729 -7.80035 25.004 -19.9303 -194 2 2.75027 14.6107 15.9518 -1.28992 -16.7566 29.7079 -195 2 2.55205 15.9391 15.3182 6.19364 -5.6546 -9.94962 -196 1 1.13925 14.6508 9.53021 19.9076 23.5081 3.98588 -197 2 2.07639 14.8825 9.77663 -29.323 -13.131 -7.88186 -198 2 1.04812 13.6993 9.55892 5.54263 -6.82879 4.76298 -199 1 13.5171 16.5199 11.5195 20.4201 8.76324 22.1576 -200 2 12.9867 17.257 11.2155 -0.855064 7.64635 -14.0191 -201 2 13.0442 15.7467 11.2378 -7.08331 -12.4379 -10.7884 -202 1 4.66723 1.48136 0.73322 23.0149 3.26353 10.1864 -203 2 3.99044 1.945 0.247475 -7.51763 5.99594 -9.81004 -204 2 4.21698 0.879204 1.33273 -6.6714 -6.19828 -5.18082 -205 1 1.48126 18.5865 11.8932 5.77456 11.9109 13.6761 -206 2 1.45047 0.509997 12.7065 -0.655319 -12.4833 -18.3988 -207 2 2.16842 17.9125 12.0331 -8.54366 2.69761 2.01722 -208 1 11.4638 10.1444 4.04596 -29.9846 -9.43843 22.7531 -209 2 11.586 10.5695 3.21678 -1.49335 12.1472 -28.3165 -210 2 12.3366 9.99459 4.35585 30.6386 -4.62302 8.08877 -211 1 8.15809 12.1698 3.75544 16.5318 -12.8496 -25.3624 -212 2 9.0168 12.5594 3.97136 -0.0903232 2.9732 11.2136 -213 2 7.55758 12.2779 4.48666 -4.55936 7.15494 21.2951 -214 1 14.57 4.03338 3.33424 -15.9396 -3.34089 -13.9779 -215 2 15.2475 4.30951 3.93522 14.2067 0.133456 17.245 -216 2 13.7488 4.35662 3.71839 -4.37522 2.77806 -1.52286 -217 1 5.69573 1.64484 7.55416 47.4861 32.5669 -28.9041 -218 2 5.02314 1.22164 8.01158 -49.1519 -34.4826 29.3881 -219 2 5.51675 1.48645 6.61188 -4.44278 2.0561 3.75596 -220 1 17.8757 1.08291 4.8338 -2.11434 0.172647 4.71576 -221 2 18.4455 1.46692 4.16357 3.67184 -2.89676 -9.33974 -222 2 18.0165 1.6381 5.60499 -0.396504 -0.0112538 6.48923 -223 1 6.85338 9.35555 4.52322 8.01303 -7.73923 12.5712 -224 2 6.71294 9.49068 5.48294 3.02765 -1.76203 -13.5451 -225 2 7.79052 9.06961 4.44068 -13.079 3.18293 -1.46589 -226 1 2.62197 14.8521 2.02937 -10.5221 3.39156 -23.0918 -227 2 3.43005 14.7674 2.51892 12.1264 -2.78802 16.39 -228 2 2.89555 15.1253 1.13827 -2.73698 -5.91865 10.4405 -229 1 17.3299 12.9421 13.1931 -12.7738 17.025 -7.03447 -230 2 16.4383 13.2606 13.4479 14.3464 -2.45707 -5.73497 -231 2 17.7945 13.7546 12.8897 -6.22536 -14.4165 5.27249 -232 1 14.8979 10.5619 1.48982 -11.9525 28.8063 14.5441 -233 2 15.3485 11.4081 1.81139 -13.0513 -30.8314 -8.90843 -234 2 13.9324 10.6539 1.67123 25.3412 1.8999 -4.23485 -235 1 5.67595 6.67872 4.55433 0.362155 18.5292 -10.9955 -236 2 5.7867 7.61135 4.29326 0.453279 -5.37291 7.09585 -237 2 6.40948 6.48302 5.14674 -0.086512 -6.41659 5.49044 -238 1 7.99316 8.32936 10.3099 -9.88556 -13.348 -36.673 -239 2 8.52429 8.77949 9.6279 3.30308 5.35046 16.0689 -240 2 7.32365 7.86355 9.75728 7.50693 2.48224 14.219 -241 1 13.4328 18.4778 5.70681 16.0844 -0.193399 -6.38488 -242 2 12.6986 0.421386 5.55211 -13.5651 7.65576 -7.58054 -243 2 13.084 17.8957 6.37412 -0.0453673 -15.2248 15.7361 -244 1 -0.0111344 2.60704 0.305045 25.2129 -30.2702 8.72131 -245 2 17.7164 2.72495 0.164021 -32.2143 -6.6311 -9.93678 -246 2 0.303096 3.48034 0.225751 24.1306 33.5707 -2.06333 -247 1 12.8325 10.9421 9.75806 8.08682 -36.6012 3.93532 -248 2 11.88 10.8422 9.79419 -10.8426 11.3849 -4.95145 -249 2 13.0795 10.0004 9.94273 0.259667 22.5692 -5.0531 -250 1 0.642026 12.1683 11.0609 4.45464 6.09796 -5.6804 -251 2 18.3356 12.2213 11.2584 6.06715 1.14224 4.76964 -252 2 1.15053 12.4132 11.8471 -8.72956 3.82018 2.8882 -253 1 5.19121 7.35128 13.362 14.2217 -1.26987 2.88721 -254 2 5.71731 8.09811 12.9969 -6.96977 -10.5111 6.72344 -255 2 5.67215 7.04852 14.1611 -4.50302 8.90065 -9.08298 -256 1 1.17753 6.82665 11.884 -6.96202 23.1207 3.27017 -257 2 0.332868 7.13942 11.4836 19.3553 -6.8941 9.30012 -258 2 1.59694 7.61812 12.3119 -7.65201 -17.5731 -13.8958 -259 1 15.4801 9.74186 12.3501 8.02403 -36.537 -7.5848 -260 2 15.2771 10.6331 12.1319 -8.61126 25.0623 0.312061 -261 2 15.6595 9.70704 13.2832 1.37326 2.5629 11.9963 -262 1 16.5169 12.594 5.50965 10.4637 -15.548 10.5874 -263 2 16.3074 13.4879 5.77305 -4.76715 16.3332 -4.64473 -264 2 16.4013 12.5274 4.55501 -3.26126 3.70708 -8.86796 -265 1 6.31292 9.82321 0.0853393 -0.254663 19.8779 15.0366 -266 2 5.47299 10.2624 0.316114 7.63969 -1.93852 0.671735 -267 2 6.95815 10.0698 0.784254 -6.58085 -1.04763 -9.09577 -268 1 12.2316 6.09819 4.0135 -11.5327 11.7492 -3.18772 -269 2 12.1819 6.93481 3.49894 6.0574 -18.2652 4.97925 -270 2 11.3139 5.7855 4.02535 4.75129 -2.10791 -0.415098 -271 1 0.346102 12.8439 0.0895734 -4.86896 0.353582 5.39062 -272 2 18.7507 13.4631 0.799834 -0.48412 -1.67542 -1.66039 -273 2 18.3682 13.0274 18.0218 -2.69393 2.08889 -5.2677 -274 1 3.5489 0.022651 8.64264 14.8213 -2.21723 6.15117 -275 2 3.34146 18.2537 7.79412 -1.37888 1.54429 -1.85278 -276 2 2.69807 0.312924 8.99074 2.91061 0.134312 -8.36673 -277 1 7.48275 17.4677 4.49597 -9.82961 -11.4008 2.47905 -278 2 7.76172 18.3639 4.65831 -0.473756 11.2371 0.709742 -279 2 7.61951 17.3416 3.55584 -1.72206 -2.44101 -5.98946 -280 1 9.27482 17.1419 12.2002 -29.9673 17.8198 -3.75997 -281 2 9.29449 16.2474 11.8858 2.76409 -17.0257 -9.00951 -282 2 9.96887 17.232 12.8306 24.004 1.27191 14.3563 -283 1 13.3881 13.0638 7.94543 23.8544 1.05207 16.0454 -284 2 13.4911 12.3591 8.61055 -7.80977 1.42534 -8.25381 -285 2 14.1677 13.6583 8.10929 -22.3675 -6.64423 -7.05202 -286 1 14.8196 2.98416 15.4059 10.9247 4.82989 11.3692 -287 2 14.1977 2.30622 15.182 -14.8004 -11.8419 -2.86461 -288 2 15.3715 3.04555 14.6288 11.3419 0.403673 -8.50968 -289 1 9.89007 15.644 16.9507 -0.476448 -13.1737 2.9886 -290 2 10.2689 14.811 16.6236 0.33136 1.14394 -2.50282 -291 2 9.50974 15.3862 17.8064 -0.51987 6.75584 -0.702029 -292 1 11.2404 8.49746 16.6126 -11.0388 -24.1902 -5.6141 -293 2 10.5493 7.95233 16.1656 11.7734 11.5748 6.95591 -294 2 11.5411 7.95338 17.3605 -0.459906 4.27214 -6.12679 -295 1 3.94653 18.1828 16.8275 -12.5536 19.575 -10.0724 -296 2 4.49583 17.6028 17.3635 4.26127 2.6886 8.36922 -297 2 3.95977 0.456308 17.1729 5.72776 -19.9128 0.46306 -298 1 2.2132 4.22212 8.91052 -3.52394 3.62108 -17.0138 -299 2 3.14576 4.09878 8.74947 8.67559 -2.34434 0.767855 -300 2 2.06536 4.03466 9.83165 -0.817379 -1.75645 17.2153 -301 1 9.87247 10.3712 9.74928 14.7683 -30.296 -5.49075 -302 2 9.62147 11.2221 9.45607 -13.6864 32.2476 -14.4563 -303 2 9.99394 10.4206 10.6874 0.365841 -1.43755 21.5864 -304 1 9.68376 0.92477 10.8522 -9.86416 -7.8375 -9.37303 -305 2 9.18791 0.169256 11.2055 11.1043 -0.796798 3.35444 -306 2 9.09399 1.23638 10.1435 10.2069 6.90097 4.69651 -307 1 9.16769 15.091 10.1956 22.4355 7.87639 6.21774 -308 2 8.9696 15.9691 9.88131 -3.17938 11.9605 -8.33522 -309 2 8.32743 14.6622 10.1389 -19.5916 -16.662 -1.08184 -310 1 0.85922 9.69743 10.2442 32.6336 -47.5631 -25.4673 -311 2 1.02374 10.6105 10.3992 -2.53948 25.7241 9.50189 -312 2 1.72313 9.35148 9.87448 -35.4256 9.68482 16.6576 -313 1 17.0256 4.81986 8.08308 31.6348 -31.2729 -9.48192 -314 2 16.3215 5.37214 8.33224 -31.3655 27.4802 10.3117 -315 2 16.9319 4.0155 8.6004 0.768816 2.34372 -1.45333 -316 1 14.8081 14.6794 0.153243 -2.85725 -11.5952 -11.9613 -317 2 15.2092 15.2804 0.771003 11.383 9.73034 15.7651 -318 2 14.0408 14.3115 0.591288 -7.92269 -3.99881 6.06231 -319 1 3.80416 11.0019 9.56526 0.623941 6.68377 2.11405 -320 2 3.77619 11.4642 10.4186 -0.043788 -6.16761 3.62327 -321 2 3.31763 11.5705 8.95624 -4.54045 6.84371 -3.4313 -322 1 11.3158 10.7476 1.45776 10.9951 -9.43983 2.74041 -323 2 11.5252 11.5694 1.01773 6.8042 14.5185 -3.76913 -324 2 10.3718 10.6573 1.35733 -14.9091 -3.38451 -2.45366 -325 1 13.1832 7.19978 12.6897 5.92706 -14.8401 5.32281 -326 2 14.1145 6.87754 12.7085 -13.0936 9.37511 -3.26372 -327 2 12.6462 6.38983 12.7968 5.91866 7.22274 -2.53959 -328 1 9.61767 1.88189 0.936979 -6.6056 8.12678 -33.3335 -329 2 8.75647 1.76915 0.468433 15.5153 -2.73343 13.4493 -330 2 10.2273 2.17983 0.230861 -6.38326 -0.489196 14.1696 -331 1 10.6523 13.47 4.56634 -17.7163 6.61907 -5.84307 -332 2 11.5562 13.1849 4.68206 11.5009 -9.86279 4.07703 -333 2 10.5151 14.0877 5.29021 -1.44258 0.681598 7.9468 -334 1 14.5213 1.69385 10.9785 0.412416 12.5139 1.3055 -335 2 15.3159 1.33414 10.5754 1.96072 -4.24727 -0.900333 -336 2 14.7412 2.63918 11.0728 -6.13642 -3.41388 -3.76294 -337 1 14.5042 12.0777 11.6111 -12.2061 0.510996 31.5423 -338 2 15.1827 12.4648 11.0978 29.2487 15.6657 -21.0239 -339 2 13.909 11.6953 10.9807 -16.843 -4.29027 -12.6849 -340 1 8.18401 5.11068 9.87002 -0.676892 -7.65738 -3.35075 -341 2 7.33939 5.06675 10.3357 0.521056 4.21206 1.1001 -342 2 8.29842 4.21721 9.50312 -0.00697362 5.6522 3.71152 -343 1 1.5768 16.9623 18.4443 13.7844 -6.06932 -11.1938 -344 2 2.08688 17.3314 17.6994 -1.29344 -1.55823 6.9248 -345 2 1.72478 16.0021 18.3853 -4.19272 5.84443 -4.03385 -346 1 1.47359 17.3466 15.3156 -41.3862 18.9515 21.4522 -347 2 1.38751 18.1942 15.8376 11.356 -22.4463 -17.1221 -348 2 0.531998 17.0202 15.2731 27.9598 4.08453 -2.72162 -349 1 3.56251 5.80266 6.06315 1.23781 -30.1986 0.952301 -350 2 2.9922 6.42371 6.50913 -3.22231 11.6367 6.59476 -351 2 4.22501 6.28135 5.5614 1.05528 7.23928 -6.44245 -352 1 12.5723 9.4951 14.2463 -14.1947 49.7353 4.36555 -353 2 12.9086 8.77822 13.7576 17.8642 -40.1771 -16.3075 -354 2 12.2963 9.16979 15.1004 -1.36164 -11.5003 11.0357 -355 1 4.07044 15.2648 6.99086 -8.22484 -15.5272 10.3185 -356 2 3.65725 16.0904 6.74002 -9.77102 8.77549 -2.61135 -357 2 5.00026 15.4315 6.88928 20.0063 2.47059 -3.54324 -358 1 0.744606 8.73408 15.0763 0.0218964 -5.95646 -3.10884 -359 2 0.519262 9.66197 15.1074 -7.84082 12.7234 2.89932 -360 2 1.47025 8.73132 14.4431 5.87969 -4.51966 -2.6491 -361 1 12.9306 8.27919 10.1905 8.08936 2.40022 19.7343 -362 2 13.779 7.90886 9.87037 -9.22858 -4.32337 9.26771 -363 2 12.8604 8.07471 11.1624 7.69549 -2.50096 -25.1681 -364 1 15.3235 7.85492 3.5497 18.4153 32.411 -54.1913 -365 2 14.4745 7.6657 3.15314 -16.0822 -13.4855 9.94503 -366 2 15.5116 7.64082 4.44166 -12.2255 -21.7424 34.152 -367 1 17.2256 6.71185 18.6385 13.0601 3.46678 -1.24204 -368 2 16.7837 5.9846 0.423329 -10.4159 -11.046 2.92977 -369 2 16.5307 7.32814 18.3852 -6.78357 2.8142 -3.2779 -370 1 8.8964 6.96848 7.83902 16.0931 16.0227 -2.80611 -371 2 9.83265 7.28699 7.8278 -17.1093 -4.77101 0.707558 -372 2 8.79691 6.46408 8.64714 -0.939429 -8.3316 9.69843 -373 1 12.4084 0.523138 1.23768 -2.06115 0.0733923 -7.11266 -374 2 13.1872 0.998726 1.54472 7.23891 -2.91784 -1.02165 -375 2 12.4662 0.537618 0.274809 1.69654 -3.93261 2.5223 -376 1 5.65468 15.0902 14.5334 3.02676 -25.5773 -0.125585 -377 2 4.72407 15.1616 14.7961 0.127409 2.72757 -0.91443 -378 2 5.99013 15.9712 14.3886 3.52657 16.2654 -6.40367 -379 1 3.82399 6.39797 1.75512 3.78691 -6.14258 3.26006 -380 2 3.37829 7.15763 1.38654 -6.41374 16.3556 -5.84968 -381 2 3.97609 6.61981 2.67876 -1.82166 -0.0414506 2.69272 -382 1 3.91801 11.4637 12.3808 6.26728 1.11409 -8.60855 -383 2 4.78798 11.8777 12.4982 -7.30712 -3.21292 -1.54071 -384 2 3.30212 12.087 12.775 -5.64928 0.778082 5.20377 -385 1 5.29676 3.85177 15.8189 3.43828 -31.27 -8.27082 -386 2 6.03967 3.23378 15.6029 -11.8461 12.1043 0.727598 -387 2 5.68429 4.70341 15.931 13.0054 23.274 1.41344 -388 1 14.2193 10.1559 4.56622 -21.9238 17.9967 10.7876 -389 2 14.2923 9.81422 5.45847 5.67938 -3.41822 10.3914 -390 2 14.6614 9.51741 4.03067 14.2685 -12.4061 -15.9356 -391 1 7.6994 17.3598 9.13069 2.58566 -7.07749 -1.38218 -392 2 6.9688 17.7373 9.6086 -11.208 -1.02501 12.7072 -393 2 7.91331 18.0249 8.47917 9.78731 5.09099 -13.1281 -394 1 4.50671 14.5226 3.97805 12.528 -25.4608 -46.8355 -395 2 4.48015 15.4086 4.24602 -0.161492 47.21 12.2969 -396 2 4.35306 14.022 4.74858 -6.07017 -24.5156 30.0525 -397 1 14.1411 7.46132 15.8217 -22.5264 -9.25347 -2.17647 -398 2 14.9826 7.35759 15.4044 20.5288 -0.540355 -7.58788 -399 2 14.3421 7.83921 16.6731 3.72262 6.08742 11.7763 -400 1 2.98184 18.372 1.90579 -20.1648 -30.237 -17.2141 -401 2 2.43548 17.7555 1.32026 19.5303 24.385 16.7936 -402 2 2.33791 0.236975 2.41065 -5.95562 0.980031 -0.0237849 -403 1 7.99445 1.58502 4.53075 18.7977 0.504684 -14.6733 -404 2 7.48712 1.99417 3.8192 -9.17378 0.780153 1.87786 -405 2 8.88078 1.50473 4.13387 -7.12077 1.17171 10.2984 -406 1 2.41951 14.1599 17.7056 22.0207 15.2121 -4.13121 -407 2 1.68443 13.6195 17.9516 -15.3327 -12.8663 8.26013 -408 2 3.18525 13.6986 18.0793 5.57496 -0.0710026 -2.65101 -409 1 0.908587 1.85846 13.8858 -0.0793858 -1.94323 14.6669 -410 2 1.14821 1.59902 14.7928 -3.46921 3.66635 -7.67361 -411 2 18.5942 2.00299 13.9058 4.01903 -0.250224 -6.72878 -412 1 4.32702 0.129386 13.8829 -0.0770511 3.08332 3.55447 -413 2 5.24833 18.5067 13.8286 4.90059 -4.64875 -2.30826 -414 2 4.05486 18.5232 14.7746 -2.81766 -1.27361 1.32354 -415 1 7.27357 0.854459 18.3804 -15.3869 4.3045 -1.1218 -416 2 7.16992 0.518993 17.4624 3.36336 5.55626 15.3605 -417 2 6.40185 1.20099 18.6914 11.5657 -10.6186 -10.5297 -418 1 15.9542 18.4046 13.9208 -25.3022 5.029 -14.7602 -419 2 15.0075 18.5254 13.735 13.8644 -2.42428 -4.09563 -420 2 16.0061 18.5076 14.8614 8.67486 -1.51607 21.0166 -421 1 10.2392 4.55204 16.2801 10.7238 -8.25817 -3.6178 -422 2 11.196 4.37813 16.4864 -24.802 4.89259 -9.76699 -423 2 9.86858 3.73489 15.891 10.2726 5.88423 10.0044 -424 1 15.9238 17.7149 4.45644 2.75189 -23.1215 -12.8271 -425 2 16.5168 18.4535 4.47728 14.6813 18.6917 2.39924 -426 2 15.0936 18.0469 4.76398 -21.0845 8.87368 10.3462 -427 1 6.95648 17.503 13.9077 -51.9825 -4.38955 -3.71365 -428 2 7.39002 17.773 14.6913 25.8751 9.72049 29.5532 -429 2 7.60747 17.4983 13.2335 27.2317 -2.92469 -23.3456 -430 1 13.2071 6.48879 6.54043 12.3601 -8.29587 -18.0485 -431 2 14.1818 6.5258 6.42811 -17.7974 6.95191 3.55269 -432 2 12.8555 6.35956 5.62691 5.37067 1.68412 18.5111 -433 1 7.86742 2.30794 9.39626 -5.35093 5.07188 8.74379 -434 2 7.30782 2.2926 10.1983 5.67726 -4.12754 -5.74363 -435 2 7.33716 1.92062 8.69482 -5.03183 0.0809058 -6.36949 -436 1 15.2078 14.7586 13.7432 0.832397 -4.30074 -2.87903 -437 2 14.8858 14.9257 14.6258 -3.94452 3.16733 11.6107 -438 2 14.9517 15.5204 13.2236 -2.78606 2.09491 -5.66724 -439 1 9.4202 8.34719 3.8485 -22.8652 4.71801 -4.87246 -440 2 10.1988 8.89706 3.87201 15.3465 4.97444 3.28263 -441 2 9.69606 7.44575 4.01411 1.53448 -7.03017 -1.02937 -442 1 17.7384 13.5884 16.4052 -11.7067 -11.536 8.32036 -443 2 16.7673 13.5542 16.377 3.38001 -6.87595 1.27552 -444 2 17.9496 14.385 15.9274 3.88108 14.0768 -7.71607 -445 1 4.90559 10.5521 2.87839 21.3367 -20.8737 -11.4011 -446 2 5.623 10.1254 3.38432 -4.07258 6.62764 -8.01418 -447 2 4.62886 11.2624 3.4373 -4.18877 12.0113 9.86562 -448 1 3.72998 8.3995 9.96949 0.206562 0.552242 5.18998 -449 2 3.80623 9.33185 9.71276 -0.050758 -4.34606 1.0469 -450 2 3.86748 8.41721 10.9275 -4.36654 -3.13592 -2.04235 -451 1 15.965 6.95365 5.95266 -6.26742 1.66997 1.55481 -452 2 16.7698 7.37181 6.25298 11.0034 6.69643 7.83926 -453 2 16.2161 6.06091 5.70554 3.02292 -8.38979 0.185448 -454 1 15.1879 7.19538 9.00463 -16.574 -33.0638 16.9279 -455 2 15.9728 7.55664 9.38717 21.7076 13.0833 8.35481 -456 2 14.9649 7.65827 8.21955 0.87619 20.3483 -26.3308 -457 1 6.20656 12.8742 12.7233 -2.45823 6.18764 -5.3718 -458 2 6.79799 12.2543 13.1384 18.4055 -9.75357 3.10315 -459 2 6.13621 13.6122 13.3363 -4.91508 8.57981 5.63651 -460 1 12.128 4.53555 13.1062 -17.5662 -8.78193 22.9206 -461 2 12.3906 4.63486 14.0411 2.44404 0.930561 -9.75427 -462 2 11.3004 4.01263 13.1714 14.0583 8.15169 -11.9376 -463 1 11.4184 8.10098 7.95437 7.14359 -3.91624 -16.2991 -464 2 12.1028 7.60478 7.4673 -7.16754 1.39876 -0.578178 -465 2 11.8093 8.18067 8.82553 -2.79742 2.89488 8.77133 -466 1 17.0514 10.8651 7.58728 -24.1088 0.784299 26.3012 -467 2 17.8144 10.3384 7.41217 20.5663 -15.9736 -11.9321 -468 2 16.8601 11.4269 6.84052 2.19633 6.48519 -17.1676 -469 1 5.231 18.0993 10.8546 26.455 4.8965 -4.82813 -470 2 4.8195 17.6908 11.6007 -11.7048 -9.88744 14.1218 -471 2 4.63699 18.0004 10.1206 -18.4061 3.17503 -16.8763 -472 1 7.59767 17.4436 1.69759 5.72815 6.19172 -16.2775 -473 2 7.89477 16.6568 1.18579 0.971667 15.0969 7.35096 -474 2 7.65141 18.2352 1.10536 -4.88626 -20.2664 5.47735 -475 1 1.93145 12.9234 13.6206 5.60545 -3.12143 -21.3855 -476 2 1.4749 12.3281 14.2061 -8.56587 -7.9862 10.2726 -477 2 2.17547 13.6903 14.1341 4.19375 11.0678 7.71152 -478 1 9.43748 6.79443 14.8327 33.0335 -30.4644 -7.71462 -479 2 9.91196 6.01751 15.25 -19.5648 18.6507 -3.60269 -480 2 9.7502 6.76156 13.9011 -9.65438 10.9618 10.9707 -481 1 15.2831 4.34212 10.7772 21.179 15.7439 -2.01388 -482 2 16.2293 4.27243 10.5111 -19.8675 -5.23 11.4528 -483 2 15.2971 5.09975 11.4021 -5.00612 -14.3562 -6.14057 -484 1 11.351 6.2072 0.109577 23.6613 28.7979 6.66193 -485 2 11.4872 5.27024 0.0694097 -6.21323 -21.6319 -6.22108 -486 2 10.4676 6.44004 18.4761 -18.3883 -9.25121 -2.88973 -487 1 18.5357 11.4228 14.9398 26.7643 -26.8403 31.1109 -488 2 18.0597 11.723 14.1947 -18.2778 17.0129 -29.9513 -489 2 18.4532 12.1424 15.5699 -5.23995 5.81903 4.32114 -490 1 7.05668 9.28071 7.31234 -6.58466 7.4517 -4.55549 -491 2 6.71011 8.47084 7.6978 -4.31789 -6.13087 1.68327 -492 2 7.98804 9.13135 7.18438 15.6823 -2.37616 0.276954 -493 1 18.324 15.3331 12.2569 -7.46978 -1.64803 5.36971 -494 2 0.564477 15.5946 11.9899 10.9599 1.36641 -5.51497 -495 2 17.7284 15.6281 11.5548 0.957946 6.58656 -2.69515 -496 1 16.4958 4.38611 5.25998 2.69003 14.057 -30.634 -497 2 16.6253 3.88668 6.0538 7.32023 -9.57738 16.711 -498 2 17.3371 4.41488 4.75201 -4.14044 -1.60108 11.4247 -499 1 17.7073 3.15256 10.779 -3.63642 -2.40486 -9.15002 -500 2 18.6235 3.40441 10.9111 8.43018 2.88916 7.88185 -501 2 17.7389 2.35032 10.2471 -2.89329 -5.91517 0.580451 -502 1 12.2813 18.6401 10.1181 2.89516 -35.5496 -8.35074 -503 2 11.4703 0.383955 10.4005 -29.8535 10.9583 6.97968 -504 2 12.9196 0.674429 10.2218 25.4798 25.6209 2.989 -505 1 10.3974 9.74216 12.5073 0.112101 -17.0368 -3.21727 -506 2 11.1947 9.82557 13.039 4.39701 4.68697 5.66162 -507 2 10.3035 8.76836 12.4158 -2.37231 15.8308 -1.56525 -508 1 0.663588 2.73535 7.12598 -12.3374 1.53361 -6.62113 -509 2 0.367817 3.62684 7.37457 5.09588 -7.68469 3.80292 -510 2 0.956045 2.28157 7.92852 1.53616 1.67998 2.79736 -511 1 0.311147 15.2759 6.88171 -13.4592 45.4783 4.03261 -512 2 0.500617 15.614 7.76495 4.81164 -9.60864 4.06796 -513 2 0.558697 14.3764 6.88071 13.8097 -37.6199 -4.57419 -514 1 17.0548 6.97395 15.0744 4.20776 -1.94343 -1.58424 -515 2 17.8177 7.57453 14.9855 -5.12063 -2.20736 -0.0554095 -516 2 17.4111 6.17613 15.4934 -0.113823 0.922547 0.618491 -517 1 9.1503 12.5213 8.01319 -14.1189 2.82879 0.278945 -518 2 9.53356 11.9725 7.3299 10.3093 -11.5802 -1.96405 -519 2 8.24075 12.6139 7.71394 -0.988228 2.45183 6.21614 -520 1 1.17609 1.70844 2.83295 3.23913 -2.31621 -1.89882 -521 2 1.09855 2.22978 2.02752 -9.74566 -1.77621 -3.35395 -522 2 1.86202 2.13223 3.34238 5.26299 8.17365 10.1548 -523 1 4.09291 15.1504 9.8922 18.1507 -7.2721 -6.40054 -524 2 4.03036 15.1629 8.92399 -1.00826 2.87435 -0.463193 -525 2 4.99389 14.8146 10.0732 -8.74469 0.915467 -5.31212 -526 1 7.37772 2.25117 14.7222 3.22505 8.21162 1.39777 -527 2 7.09502 1.54536 14.1374 1.57311 -0.181539 -4.41158 -528 2 7.85635 2.90205 14.1691 -14.4419 -9.06063 9.37489 -529 1 18.4006 14.5833 2.15968 -9.78242 8.50711 -1.4388 -530 2 0.62994 14.8842 2.46282 -4.8788 5.17113 -0.292034 -531 2 17.7517 15.3351 2.17575 17.725 -12.6913 0.414249 -532 1 9.99197 2.68277 12.9223 -2.58103 11.7713 -8.17336 -533 2 9.96789 2.1685 12.101 0.346485 -5.49174 3.23624 -534 2 9.29748 3.35451 12.7936 3.47695 -5.23648 4.96996 -535 1 2.96299 8.91941 13.096 19.2939 -0.203164 0.561242 -536 2 3.4486 9.7527 12.8428 -15.067 -18.0348 7.07188 -537 2 3.65865 8.27445 13.3679 -12.9331 14.6867 -6.35999 -538 1 3.26147 8.578 3.77304 6.38222 5.3653 -9.36202 -539 2 3.78874 9.26676 3.32736 -9.65467 -7.00498 -1.39723 -540 2 3.24393 8.8647 4.68594 3.08129 -4.64857 6.90262 -541 1 5.77287 7.24333 8.61048 -1.78661 -5.00814 9.07462 -542 2 5.68022 6.28289 8.53661 4.0016 -1.85755 -4.86386 -543 2 5.00276 7.50215 9.14094 4.61323 4.45406 -2.92895 -544 1 14.8793 1.52937 1.85035 -12.7334 -14.0835 12.9397 -545 2 14.819 2.16152 2.5876 10.8144 6.55959 -13.4181 -546 2 15.5594 1.73936 1.19754 -2.84827 11.2594 2.6977 -547 1 8.5607 15.0611 0.725284 0.46926 -2.1008 2.83341 -548 2 9.29259 14.9147 1.35885 -7.99161 6.01774 -7.32206 -549 2 7.81927 14.5289 1.05772 1.7687 -2.35649 0.826934 -550 1 15.4921 1.3993 7.20702 14.746 2.01238 2.95597 -551 2 14.8484 0.891915 6.72418 -10.4472 -9.96976 -7.88743 -552 2 15.1077 2.27361 7.28199 -8.00989 7.94424 8.07076 -553 1 5.01058 12.9585 18.4386 -15.8567 -4.4202 8.08993 -554 2 5.4193 13.0053 0.667327 2.46468 -0.195888 1.58163 -555 2 5.59523 13.4446 17.8643 8.60291 1.11734 -4.66644 -556 1 15.4019 8.61725 18.0949 -10.0539 -8.80276 13.7753 -557 2 15.8344 9.23888 17.5182 6.53635 7.63687 -15.5634 -558 2 15.1418 9.16559 0.203922 1.58583 0.47418 3.18719 -559 1 12.0525 3.11208 18.2861 7.73999 -14.4321 9.61497 -560 2 12.4007 2.82569 0.495607 -5.57788 10.1171 1.38067 -561 2 12.4066 2.43321 17.7002 -1.56388 4.26076 -9.69121 -562 1 13.1688 12.6857 5.1494 7.31226 -7.20074 3.10637 -563 2 13.4985 11.8462 4.78426 1.65488 6.62932 1.41885 -564 2 13.3525 12.6203 6.1046 -3.90991 6.43934 -4.24709 -565 1 6.08926 7.21668 0.130178 -1.88627 11.2856 16.2629 -566 2 6.12641 8.19603 18.8427 -2.9512 -23.7133 -6.32338 -567 2 5.32645 6.95656 0.679872 3.54107 -2.60359 -10.7249 -568 1 17.6547 15.8703 14.9132 16.2429 2.82715 17.6162 -569 2 16.6953 15.9075 15.0555 4.78919 3.7515 -14.6122 -570 2 17.9345 15.7768 13.9856 -18.469 -1.14955 -2.42085 -571 1 13.1468 0.885591 16.7291 -10.7864 15.024 2.10847 -572 2 14.1008 0.813897 16.7431 10.5998 -4.62802 3.60151 -573 2 12.8375 18.6536 16.4909 -4.88764 -9.34618 2.57866 -574 1 10.8908 14.4992 7.43136 -2.2343 -7.03539 12.0134 -575 2 10.0835 14.2065 7.92308 22.5278 2.1252 -13.3834 -576 2 11.6003 13.8396 7.60224 -11.7269 11.3777 -3.99947 -577 1 17.6181 8.42363 2.12766 -11.9935 -3.6797 -6.77545 -578 2 16.7343 8.37762 2.55285 14.0369 1.72981 -7.6286 -579 2 17.5632 7.81953 1.35766 3.76606 6.32419 13.0143 -580 1 12.3929 7.83138 2.01819 4.71096 17.5308 0.40727 -581 2 12.1717 8.7272 1.7221 -1.13772 -2.1217 4.67191 -582 2 11.9464 7.25327 1.39471 0.282935 -6.68024 -6.10503 -583 1 12.0275 14.6478 10.4009 38.9809 -24.2439 -10.9711 -584 2 12.337 14.044 9.6932 -4.28518 13.1756 12.472 -585 2 11.1105 14.7441 10.2592 -43.0899 4.37787 -4.57767 -586 1 6.8265 6.93238 15.5327 -27.6581 -7.97269 5.64053 -587 2 7.73103 7.08984 15.3178 26.4357 1.09681 -7.32033 -588 2 6.59533 7.63547 16.1384 -2.46814 3.13878 5.80205 -589 1 7.96021 4.51991 13.281 5.98272 36.635 4.98876 -590 2 7.18773 4.72006 12.7149 7.22552 -5.34662 5.9239 -591 2 8.2239 5.40342 13.6709 -8.7699 -31.8396 -11.1478 -592 1 13.3799 12.1942 14.3144 0.413244 -2.26196 2.0512 -593 2 13.2473 11.2333 14.3131 -4.23433 1.2327 0.0241848 -594 2 13.7366 12.3802 13.4362 1.03232 3.06063 -1.77089 -595 1 14.6196 9.43974 7.2819 12.1284 19.1611 12.5008 -596 2 15.4631 9.9012 7.50833 -13.143 -10.3991 -7.78335 -597 2 13.9498 9.89967 7.80701 0.241302 -5.62146 -3.59828 -598 1 12.6688 16.8855 3.24635 -1.47445 -34.5545 -0.541717 -599 2 12.9124 17.3724 4.01195 4.0393 16.1159 25.6755 -600 2 12.6994 17.4999 2.53895 -2.71389 24.0914 -25.4271 -601 1 1.00064 7.12258 17.3474 25.8989 -13.4919 10.9638 -602 2 0.199171 6.81692 17.7654 -17.9333 6.12878 2.90109 -603 2 0.781412 7.72916 16.646 -4.92956 7.36441 -13.84 -604 1 12.947 4.88013 15.7213 -21.2986 7.3754 -0.931645 -605 2 13.7769 4.45629 15.8524 19.8874 -20.9291 -0.114876 -606 2 13.1805 5.80207 15.7513 2.74699 20.2475 2.05037 -607 1 2.36441 3.38825 5.1495 13.4973 -9.76059 -50.575 -608 2 1.87697 2.96062 5.81278 -27.3053 -18.1487 33.2377 -609 2 2.7907 4.09602 5.58982 16.1263 32.9476 11.4061 -610 1 8.23368 10.9868 13.6471 -16.5646 12.9957 -7.98974 -611 2 8.32411 10.9316 14.5895 -0.490848 -4.77914 16.6738 -612 2 9.07298 10.6867 13.3074 11.7511 -8.07538 -9.61613 -613 1 13.0107 1.52025 13.2616 -13.3177 -0.0328213 18.9383 -614 2 13.4383 1.61013 12.4179 13.267 -2.68379 -13.3373 -615 2 12.5185 2.34771 13.3673 3.11016 -7.04189 -1.75869 -616 1 6.59377 13.5764 2.15874 -7.12741 11.9903 -27.1264 -617 2 6.00679 13.9468 2.8128 -10.8754 6.0075 10.3445 -618 2 7.2163 13.0692 2.66145 9.56033 -10.8956 7.78491 -619 1 15.8548 6.42593 12.5881 24.8624 13.3217 16.2273 -620 2 16.4838 6.96617 12.0488 -16.1868 -9.65605 6.77151 -621 2 16.2214 6.49686 13.512 -7.09801 -2.27572 -23.2114 -622 1 16.7956 0.692247 9.54535 7.46915 17.7641 2.49637 -623 2 16.5452 18.5156 9.96298 -0.0131793 -20.516 -0.238231 -624 2 16.2976 0.789947 8.72228 -2.61192 -2.24486 -4.75056 -625 1 6.11318 11.627 8.27064 9.91462 44.2797 -2.20509 -626 2 5.35292 11.2978 8.70378 -29.3613 -6.33495 17.8965 -627 2 6.52877 10.8496 7.97791 23.4734 -34.8725 -13.0112 -628 1 2.81389 8.67751 0.381383 10.1752 -8.74242 -1.84173 -629 2 2.33278 8.32184 18.2713 -4.10181 -2.8979 1.44899 -630 2 2.25425 9.35695 0.757627 -6.74555 6.18422 5.10447 -631 1 10.1136 10.3815 6.5683 -3.97178 -1.84722 1.40214 -632 2 10.6776 9.73953 7.0164 -1.23094 -3.31757 4.86865 -633 2 10.3499 10.3203 5.64027 4.41826 3.29106 -4.73543 -634 1 6.84727 15.7748 6.6764 -14.7135 -11.7826 9.04786 -635 2 7.02398 16.1904 7.53289 5.38031 2.81892 -3.47781 -636 2 6.91879 16.4549 5.99719 9.07918 3.78678 -4.16926 -637 1 6.52182 12.8956 5.7943 0.541827 3.55761 1.99739 -638 2 6.55778 13.7774 6.19915 3.14226 -1.33255 -2.96851 -639 2 6.13082 12.3068 6.44859 -0.859963 5.03094 3.84811 -640 1 16.7567 12.5314 9.76383 -4.64367 0.23861 8.75508 -641 2 16.9908 11.8798 9.10281 -4.06168 -8.34407 -5.30318 -642 2 17.2898 13.2837 9.5332 2.7418 12.1851 0.697411 -643 1 6.23186 2.86269 2.75104 2.97881 8.48666 -1.38882 -644 2 6.52094 3.78037 2.52233 -11.0321 -17.6889 -1.77294 -645 2 5.63962 2.52843 2.04764 8.59188 6.36028 2.68011 -646 1 10.7835 3.03466 3.2504 -5.97107 -1.61798 -4.71292 -647 2 10.2628 3.82076 3.45136 1.61481 0.158577 0.983482 -648 2 10.306 2.59283 2.52669 4.73542 2.88639 2.9637 -ITEM: TIMESTEP -80 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.82629 6.70343 17.8553 -15.1071 8.15122 13.6853 -2 2 7.99416 6.85162 18.349 10.9787 -1.12299 -6.8679 -3 2 8.57507 6.09547 17.1643 3.5075 -8.11573 -6.04158 -4 1 0.137192 8.33532 6.74353 12.0191 -20.4001 -6.39938 -5 2 0.250097 8.10589 5.79669 -2.0008 6.10915 10.6578 -6 2 0.653601 7.63933 7.2162 -12.3825 18.3147 -3.0068 -7 1 8.60149 0.29664 6.93203 12.1667 -9.17994 12.1946 -8 2 9.52501 0.228788 6.64808 -5.75422 4.1152 -0.42095 -9 2 8.21226 0.977159 6.3883 -5.16274 6.48178 -7.47064 -10 1 6.50463 1.68869 11.7262 -16.2706 -7.92373 -2.85274 -11 2 5.9813 2.3145 12.2428 -2.71472 -2.47934 -1.80386 -12 2 5.86927 0.986784 11.4354 16.7384 10.0214 6.53226 -13 1 6.9131 5.55027 2.37535 3.77295 -5.39511 9.11334 -14 2 6.43692 5.84081 3.17655 -0.921031 3.98795 -14.1822 -15 2 6.69543 6.14979 1.6478 1.12895 -1.48609 4.32855 -16 1 16.196 10.2371 16.1388 -31.5516 2.77844 19.9706 -17 2 16.8915 10.3643 15.5412 37.4 6.14414 -23.2997 -18 2 15.8469 11.1288 16.3108 1.55641 -10.2432 -3.37881 -19 1 10.775 14.9631 2.31622 -5.5944 -0.094079 7.63582 -20 2 10.598 14.4521 3.12767 5.78422 3.02899 -5.84463 -21 2 11.1066 15.8146 2.64245 2.43259 -3.51347 -1.1859 -22 1 17.165 8.21001 10.8825 14.1674 -5.9779 -9.25967 -23 2 16.5809 8.83567 11.3092 -8.03296 12.2385 6.15632 -24 2 17.9797 8.71133 10.6858 -5.20793 -0.650283 -1.86008 -25 1 14.6097 15.9558 16.401 14.8916 -7.54315 9.24646 -26 2 13.6847 16.2494 16.4321 3.25844 -2.02272 0.00765398 -27 2 14.8063 15.4932 17.2527 -13.7355 5.39716 -16.4095 -28 1 12.117 13.3155 0.580411 -1.24587 -0.207976 3.78722 -29 2 11.7909 13.4576 18.3369 0.57388 -2.32058 -15.0609 -30 2 11.6242 13.9531 1.10951 4.78037 0.383607 7.31905 -31 1 9.34228 5.488 3.85121 53.6451 1.51077 14.3512 -32 2 8.91013 5.51861 4.6996 -19.4462 -5.34697 10.1126 -33 2 8.70488 5.4763 3.16894 -36.9473 -0.666442 -22.4182 -34 1 1.61615 3.95559 11.5848 -7.57046 15.5603 -11.9076 -35 2 1.66987 4.89506 11.8258 -4.51216 0.523906 3.16779 -36 2 2.10845 3.4705 12.2371 10.5178 -10.3797 12.993 -37 1 2.10284 6.89743 8.15957 -0.837321 -0.675751 7.8246 -38 2 2.47895 7.28827 8.96165 1.07034 3.30836 -6.30935 -39 2 2.071 5.95646 8.37348 -2.86121 -4.48577 -0.939591 -40 1 5.32433 4.44486 7.86972 -1.34052 23.2477 3.45796 -41 2 5.46877 3.5107 7.98026 -0.0649778 -19.4924 -5.7669 -42 2 4.70188 4.60713 7.1427 0.919422 -2.43856 3.29815 -43 1 3.32435 2.88678 17.4197 -1.88929 -9.6261 16.8991 -44 2 4.05816 3.29734 16.977 14.1471 9.33662 -16.3951 -45 2 2.86083 3.59453 17.8818 -3.32176 6.96255 1.50629 -46 1 7.47308 5.51417 6.17701 6.20604 7.73103 -29.885 -47 2 7.95124 6.07722 6.78768 5.01174 3.41934 10.0258 -48 2 7.09189 4.79949 6.66958 -7.20601 -9.71089 14.7057 -49 1 9.80158 6.99902 12.0223 -22.5784 -4.24274 -21.2019 -50 2 10.1069 6.1805 11.5916 -0.00510546 9.67372 7.70676 -51 2 9.03411 7.28611 11.4542 20.6129 -4.31213 14.2424 -52 1 14.1091 3.78361 8.12438 -15.7573 21.5912 -11.6445 -53 2 13.5201 4.50308 7.77049 18.8532 -19.0333 8.38218 -54 2 14.3457 4.04736 9.022 0.199067 1.13361 3.22772 -55 1 4.50215 17.2152 3.88612 2.87802 -1.37968 10.5361 -56 2 5.34021 17.6676 3.86593 13.8498 1.95887 5.68097 -57 2 3.97594 17.6789 3.24294 -11.45 0.485265 -14.6478 -58 1 16.2741 16.534 10.4726 -5.67102 -12.8311 -21.8814 -59 2 15.486 16.5615 11.0293 -1.33881 1.5325 0.205711 -60 2 15.9943 16.0074 9.67798 5.00326 13.1852 19.554 -61 1 1.98121 4.83276 0.125548 -2.90665 -21.863 0.561723 -62 2 2.62989 5.11603 0.769738 5.61812 10.8419 9.00632 -63 2 1.75087 5.59897 18.2498 0.950825 13.4626 -6.91806 -64 1 11.2654 13.2951 16.4195 -4.34554 -2.68737 -1.67212 -65 2 10.7681 12.4683 16.4833 0.87563 -1.05494 5.85319 -66 2 11.8765 13.1105 15.7039 6.19214 3.55339 -6.25188 -67 1 10.1028 10.9035 16.8331 17.2825 8.49241 1.71185 -68 2 10.5205 10.0327 16.7798 -0.767632 10.3686 4.9905 -69 2 9.17724 10.7556 16.7424 -24.4211 -4.37906 -2.41009 -70 1 11.8507 17.4827 13.4696 7.63981 7.03239 -1.88788 -71 2 12.509 16.94 12.9947 -8.02315 8.08552 1.57387 -72 2 12.1795 18.4053 13.408 -3.08283 -9.25718 -0.840972 -73 1 6.44601 9.4433 12.2773 8.37995 -15.986 -34.1351 -74 2 7.00514 9.1357 11.5138 -12.9725 10.8563 23.5312 -75 2 7.03346 9.94503 12.8365 5.04668 8.97956 7.26084 -76 1 16.2979 12.8575 2.71922 -11.7369 16.949 2.19382 -77 2 17.1652 13.221 2.45954 -10.8006 -1.31331 4.0939 -78 2 15.6758 13.6404 2.78783 18.0783 -23.2667 -2.52892 -79 1 0.707968 12.7192 5.87585 -9.46746 -3.17244 -7.34712 -80 2 1.05314 12.7932 4.98248 12.8843 -1.39545 -4.60697 -81 2 18.4375 12.4692 5.68303 -3.12969 3.97578 10.4064 -82 1 5.29671 16.347 18.4316 -9.43352 6.10902 0.949816 -83 2 5.62099 15.5668 17.9615 5.22561 3.70018 3.69326 -84 2 5.92538 16.5961 0.477291 0.486221 -4.47534 -1.04063 -85 1 0.707184 7.70367 4.119 -51.5024 -35.8612 26.1825 -86 2 0.14378 7.97362 3.40377 -12.5647 4.97441 -12.5535 -87 2 1.50957 8.08535 3.91273 65.7491 26.1316 -14.6887 -88 1 3.20348 9.03456 6.50534 -36.9666 27.611 -24.7826 -89 2 3.63112 8.56754 7.174 27.0077 -25.2244 35.3222 -90 2 2.25579 8.96355 6.72902 9.17057 2.1904 -6.46933 -91 1 7.27937 10.3761 16.2413 -0.230914 -4.48303 6.76598 -92 2 6.52755 10.9587 16.1419 -2.56448 5.11938 -3.06937 -93 2 7.11485 9.96393 17.0986 -0.495486 0.80288 1.59662 -94 1 11.0332 0.910989 5.0177 -6.88619 -3.17881 -8.23488 -95 2 10.972 1.75479 4.54866 7.92386 3.49104 7.17877 -96 2 10.6826 0.325395 4.32946 5.79259 -4.26916 6.55693 -97 1 4.2654 2.89302 13.1773 0.694211 20.6748 -2.64105 -98 2 4.39238 3.45448 13.9576 1.0821 -9.7456 0.782255 -99 2 4.16489 1.98946 13.4871 -0.702651 -10.6992 3.24412 -100 1 8.43419 10.272 1.79599 3.30535 -21.7188 -14.6566 -101 2 8.19585 10.8779 2.48837 0.0509316 11.2873 19.613 -102 2 8.53541 9.39344 2.20281 2.46081 9.96427 2.84146 -103 1 10.2486 1.68186 15.4597 -14.9494 5.38019 -3.47887 -104 2 11.0964 1.37036 15.7536 17.388 -0.916576 -1.92962 -105 2 10.2694 1.89097 14.5087 2.57313 -1.10767 6.05091 -106 1 2.6143 12.7739 7.92246 0.947228 -0.997667 -1.9326 -107 2 3.16975 13.4683 7.54148 -0.729705 2.73148 -0.490338 -108 2 1.96608 12.5591 7.23618 1.36975 0.244975 0.56737 -109 1 3.86268 11.7535 5.00307 -14.4028 -3.16999 8.33757 -110 2 3.70976 11.1475 5.74815 1.12966 3.67823 -8.44516 -111 2 3.06255 11.7297 4.44022 7.7842 4.67892 9.37694 -112 1 6.76061 14.5167 16.9537 -0.888094 -7.58336 -2.84579 -113 2 7.48488 15.1306 17.0914 4.64858 -1.1877 -1.93173 -114 2 6.56705 14.5225 16.0035 -2.02875 6.77169 3.29706 -115 1 14.2034 14.5245 3.20058 -0.0398844 -12.3077 5.38397 -116 2 13.8793 15.4221 3.34301 -5.62621 -2.27359 -1.58508 -117 2 13.7959 13.9448 3.87781 2.42748 11.415 -6.18352 -118 1 8.70505 18.0887 16.0942 -64.5065 -8.09898 -3.91687 -119 2 9.21396 17.4083 16.5058 25.0639 -11.349 2.42178 -120 2 9.16407 0.206988 15.7928 30.835 22.2192 -2.21878 -121 1 4.63692 1.68417 4.88655 37.1566 -9.63698 -3.58798 -122 2 3.87701 2.22405 4.82391 -30.2785 19.7734 3.84799 -123 2 5.28246 2.1077 4.29595 -5.87377 -5.36693 3.35208 -124 1 15.0131 12.6297 16.4887 -20.293 3.22713 36.7225 -125 2 14.5244 12.6173 17.3484 21.3151 5.53737 -15.2497 -126 2 14.2857 12.586 15.869 -0.208138 -0.973548 -24.0506 -127 1 15.729 18.4304 16.8576 -8.95075 23.4819 -17.3869 -128 2 16.2245 18.5231 17.6612 15.7889 -2.20706 14.0604 -129 2 15.4698 17.5226 16.786 -7.06215 -23.0828 1.02158 -130 1 1.394 1.31209 16.6703 -16.8241 -3.16738 2.04331 -131 2 2.15084 1.87826 16.8449 0.715689 -4.34048 -2.49358 -132 2 0.715561 1.66179 17.2756 6.00571 -5.18273 -5.07353 -133 1 18.2252 4.3402 15.9772 -8.55569 -2.73 -13.6324 -134 2 17.823 3.76125 15.3072 5.10239 5.23383 8.49054 -135 2 0.492866 4.4785 15.7127 2.39871 -0.864238 1.29175 -136 1 12.1265 17.032 16.1255 -25.5416 -7.58495 15.967 -137 2 11.3669 16.5924 16.5691 16.6277 5.86514 -1.80192 -138 2 11.8242 17.0598 15.2127 8.00105 4.8532 -10.0676 -139 1 16.1291 2.68344 18.211 0.375456 -13.3929 15.5569 -140 2 15.6138 3.3874 18.6109 -0.098248 15.4546 -4.83257 -141 2 15.8549 2.61026 17.3068 -10.5356 1.78345 -20.9571 -142 1 6.60182 13.7939 10.068 9.2492 3.65708 4.18485 -143 2 6.57275 13.4224 10.9661 -3.78941 -3.14938 -5.19226 -144 2 6.71396 13.0652 9.44214 -7.17216 -3.95227 2.85982 -145 1 10.1302 18.5571 2.70452 28.7428 2.61674 -1.08827 -146 2 10.6588 0.134354 1.90491 -8.77267 0.774664 16.1596 -147 2 9.28539 18.2699 2.40893 -22.5926 -9.32297 -10.0302 -148 1 3.0625 17.7033 6.15366 -32.6923 -3.28618 14.6113 -149 2 2.13754 17.6931 5.7562 38.9757 -0.864197 5.33283 -150 2 3.7049 17.7316 5.44436 -0.964713 0.371031 -13.1926 -151 1 12.6087 16.7853 7.93012 21.3772 -3.32102 -23.3093 -152 2 11.8409 16.2517 7.71322 -11.0279 -6.8961 6.738 -153 2 12.4183 17.3739 8.65053 -14.1479 13.0972 16.1976 -154 1 14.9031 15.2939 8.2802 -30.4011 23.5185 11.3145 -155 2 14.1656 15.9721 8.20757 23.4522 -23.8051 0.0341398 -156 2 15.3634 15.3182 7.4362 3.9964 4.48103 -1.46252 -157 1 17.8706 18.2596 0.245663 2.0948 -17.0514 -11.0411 -158 2 18.6148 17.6985 18.5349 -15.5847 20.6608 16.06 -159 2 18.229 0.448391 0.574358 6.37924 -1.254 -0.87753 -160 1 0.806491 10.487 1.42673 -7.2326 -9.98023 10.4462 -161 2 -0.00161399 9.98055 1.66044 10.6613 4.25192 -4.69396 -162 2 0.557346 11.1929 0.820979 -4.09494 2.43397 -4.83249 -163 1 1.83456 12.2686 3.29043 -8.34448 2.57963 -8.45001 -164 2 1.36787 11.5875 2.7525 13.033 10.6511 2.37549 -165 2 2.15971 12.967 2.6794 -8.27007 -10.3927 7.15994 -166 1 0.688934 17.2807 4.96532 -1.28513 13.5074 -14.6034 -167 2 -0.0176841 17.9487 5.11769 8.40666 -17.1979 3.35047 -168 2 0.596617 16.4414 5.43231 -12.6974 4.79178 9.39957 -169 1 1.09014 0.907525 9.3383 6.29421 1.3921 30.3575 -170 2 1.25758 0.656293 10.2983 -10.9635 5.07818 -25.2558 -171 2 0.281108 0.475301 9.05696 -4.67463 -4.0945 4.23309 -172 1 16.7684 2.39691 13.3495 9.61769 42.5491 2.72371 -173 2 16.904 2.78957 12.4595 -0.731435 -13.0756 10.2936 -174 2 16.527 1.48948 13.2642 -5.98641 -27.7824 -4.48506 -175 1 2.71373 15.9459 12.053 -3.75115 0.267025 20.4445 -176 2 2.98439 15.5717 12.9162 -2.14108 4.62523 -16.3505 -177 2 3.30112 15.6057 11.3695 4.80572 -2.00813 -1.58569 -178 1 16.3912 15.5658 6.1364 -18.5193 -23.7813 -1.39285 -179 2 17.3153 15.4712 6.31079 23.2449 0.130836 8.54259 -180 2 16.3263 16.278 5.5153 -3.20698 17.7917 -15.4301 -181 1 5.73039 5.21537 11.7967 -2.24013 5.33831 8.85226 -182 2 5.58704 6.03693 12.3192 -1.36073 -15.5687 -10.3459 -183 2 5.0707 4.59019 12.1393 4.45693 0.898588 -6.68224 -184 1 15.134 4.90094 0.781902 20.2218 -12.3751 4.08616 -185 2 14.9115 4.68422 1.69179 -1.28767 -2.72314 10.4735 -186 2 14.3889 5.35469 0.437757 -23.5901 14.4279 -10.7703 -187 1 16.3592 16.4594 1.89384 25.1746 19.6936 -18.9686 -188 2 16.2469 16.8 2.79117 -6.86302 3.67352 0.481682 -189 2 16.829 17.1783 1.36994 -16.7874 -21.2348 17.437 -190 1 0.175681 4.85349 3.94905 -38.6563 1.2533 -4.07114 -191 2 0.373462 5.78529 3.89581 11.5619 13.3417 2.94095 -192 2 0.969717 4.36237 4.02266 30.2668 -11.0427 7.4994 -193 1 2.99204 15.0813 15.1763 -0.305205 14.4793 -34.7595 -194 2 2.88713 14.6595 16.0135 -9.94348 -6.29569 26.5741 -195 2 2.4481 15.8945 15.1967 6.07768 -3.34342 6.9782 -196 1 1.12287 14.6661 9.5226 42.1359 23.511 16.8308 -197 2 2.04871 14.8527 9.88052 -40.3465 -4.39318 -17.9218 -198 2 1.08708 13.7187 9.50981 -4.88478 -15.9854 1.2011 -199 1 13.5299 16.5144 11.5405 11.2356 18.9117 4.33104 -200 2 13.1159 17.2557 11.0661 2.81218 -0.6798 2.92705 -201 2 13.1037 15.7572 11.1579 -10.8238 -16.1215 -4.14744 -202 1 4.70977 1.52963 0.718559 3.58248 -24.4192 11.8527 -203 2 4.08939 1.89433 0.0933404 -5.33693 14.3563 -9.66083 -204 2 4.20955 0.796838 1.1277 3.32575 8.01941 1.68952 -205 1 1.50238 18.6141 11.9042 -1.38031 13.5472 16.8753 -206 2 1.45658 0.425239 12.7856 -0.241625 -6.75063 -24.7438 -207 2 2.14944 17.9089 11.9973 -1.06457 -6.06855 3.15913 -208 1 11.4462 10.1354 4.10554 -27.8103 0.519562 13.0103 -209 2 11.5399 10.6236 3.29381 1.04561 4.25273 -17.1067 -210 2 12.3232 9.96387 4.39943 30.3669 -4.33072 3.08727 -211 1 8.16113 12.1728 3.80004 4.97071 -3.14572 14.2587 -212 2 8.9952 12.5305 4.11747 11.4774 1.91239 -11.4095 -213 2 7.64202 12.24 4.61417 -11.8418 -2.63078 -6.07404 -214 1 14.5844 4.03291 3.36716 -4.11232 -3.55002 -24.3582 -215 2 15.2517 4.33672 3.97304 10.7234 0.0718586 14.5399 -216 2 13.7453 4.32617 3.71649 -8.9869 4.72015 4.68372 -217 1 5.72064 1.64489 7.5839 32.9059 28.6425 0.0988457 -218 2 5.06921 1.12259 7.98588 -34.2591 -28.2453 24.4599 -219 2 5.39575 1.74393 6.6993 -3.28926 -2.3453 -25.2911 -220 1 17.8815 1.07824 4.83341 -4.77439 -8.44394 -0.469265 -221 2 18.4195 1.29399 4.06103 3.32925 4.9906 2.38586 -222 2 18.1973 1.60106 5.58304 1.56226 2.04575 -0.708791 -223 1 6.854 9.3046 4.53528 10.3956 -9.62802 3.27507 -224 2 6.69426 9.36632 5.492 2.76918 3.19153 -6.51095 -225 2 7.80605 9.0738 4.45229 -13.5827 1.70924 -0.808399 -226 1 2.59539 14.8276 2.04954 -21.4179 -5.20739 -34.911 -227 2 3.34516 14.7063 2.60932 22.2061 -1.352 15.1427 -228 2 2.90646 14.7931 1.11821 -3.29515 2.22824 22.2692 -229 1 17.3057 12.9587 13.1574 -14.3584 11.8265 -1.68619 -230 2 16.4238 13.3017 13.4505 21.6076 -1.54195 -11.2195 -231 2 17.8123 13.7306 12.814 -13.7958 -9.76612 7.37248 -232 1 14.8715 10.5568 1.52593 -13.8049 33.9422 19.399 -233 2 15.3968 11.3309 1.89043 -12.48 -24.7346 -11.1652 -234 2 13.9264 10.776 1.72699 26.333 -7.21409 -8.066 -235 1 5.65075 6.69227 4.53589 -1.16643 0.470211 -4.08107 -236 2 5.90168 7.60385 4.33311 1.92457 3.57872 5.04239 -237 2 6.31691 6.35225 5.15026 1.24698 1.28263 2.78678 -238 1 8.00933 8.29789 10.2803 -8.03608 2.46456 2.45807 -239 2 8.54459 8.86115 9.67988 -10.051 -7.82575 5.32423 -240 2 7.18397 7.98917 9.84875 17.8376 0.213066 -8.74409 -241 1 13.4452 18.4811 5.71348 30.3006 1.0471 -14.1486 -242 2 12.642 0.299737 5.48582 -19.0854 8.92614 -0.688815 -243 2 13.1967 17.7426 6.25238 -10.7462 -10.7439 19.4962 -244 1 -0.0119027 2.59488 0.354931 35.8038 -39.8932 13.3955 -245 2 17.7273 2.51611 0.10594 -24.5443 11.4005 -8.19311 -246 2 0.27212 3.48779 0.285479 3.99253 30.2779 -6.4317 -247 1 12.849 10.869 9.75158 -6.21929 20.5855 -7.88953 -248 2 11.8713 10.9784 9.78619 15.6811 -13.8069 -0.457669 -249 2 13.0615 9.92753 9.83861 -13.7986 2.36182 2.76964 -250 1 0.623186 12.214 11.083 4.78072 12.4497 9.66308 -251 2 18.3291 12.2937 11.2784 -7.07035 -2.86266 -6.1852 -252 2 1.03568 12.566 11.8864 5.16139 -3.44089 -5.05626 -253 1 5.24317 7.35288 13.329 16.5645 10.6427 9.86574 -254 2 5.81232 8.06371 12.9598 -16.2044 -6.02954 3.80806 -255 2 5.63373 7.21351 14.2126 -3.74153 -4.80134 -10.81 -256 1 1.17457 6.8033 11.9036 -23.8679 10.4664 -9.71638 -257 2 0.289623 7.06715 11.5324 26.398 -8.64759 11.7652 -258 2 1.56564 7.61974 12.2537 0.753648 -2.9175 -1.70229 -259 1 15.4919 9.76734 12.3795 0.0614124 -7.36309 3.05776 -260 2 15.0846 10.6319 12.2391 7.36463 -2.83561 -3.47144 -261 2 15.8873 9.82027 13.2467 -0.105969 -0.524429 6.2821 -262 1 16.5022 12.5635 5.51418 5.92626 -4.93161 -13.1981 -263 2 16.3002 13.4761 5.69188 -2.75562 16.3616 9.80459 -264 2 16.3759 12.5305 4.55079 1.66896 -8.7704 1.12914 -265 1 6.31756 9.85145 0.122373 -12.0354 8.37982 6.54531 -266 2 5.4699 10.2439 0.423151 12.3884 -4.45977 -3.2374 -267 2 6.98984 10.1338 0.758446 2.49067 2.04662 0.271789 -268 1 12.1918 6.08954 4.01066 -16.388 -25.9861 2.6766 -269 2 12.1912 6.72626 3.29268 0.559249 7.6643 3.09763 -270 2 11.3251 5.63233 3.94387 14.2823 13.1494 2.08097 -271 1 0.332379 12.8663 0.0441745 0.0508304 2.00456 8.93046 -272 2 18.9019 13.5185 0.756349 -7.27218 -2.99587 0.981784 -273 2 18.3327 13.1573 18.0278 2.80865 -1.79272 -4.8195 -274 1 3.54313 0.0443203 8.66238 11.9606 -6.13667 -3.48184 -275 2 3.32458 18.1774 7.87344 8.237 1.02812 -5.83338 -276 2 2.68777 0.391851 8.89446 -8.31408 9.03305 4.42594 -277 1 7.44404 17.5122 4.49167 0.119683 3.6114 3.91179 -278 2 7.85567 18.3869 4.65486 -14.0238 -13.6963 -7.23825 -279 2 7.39901 17.3877 3.53399 5.58618 2.96743 1.37553 -280 1 9.26713 17.153 12.2094 -20.2295 17.8608 7.81194 -281 2 9.28392 16.3133 11.7674 1.3049 -15.888 -12.5165 -282 2 10.076 17.208 12.7094 15.0452 0.291548 7.10451 -283 1 13.4068 13.0832 7.92217 -6.10698 -2.73533 15.5952 -284 2 13.4694 12.4257 8.66119 -0.459118 13.24 -15.7611 -285 2 13.8946 13.8972 8.17425 4.86633 -17.7849 -1.17812 -286 1 14.7977 2.95386 15.4326 21.7471 11.1646 11.1554 -287 2 14.1505 2.32893 15.1446 -13.9872 -17.9607 -8.38755 -288 2 15.4352 3.02911 14.7173 3.23846 -4.77681 -7.04868 -289 1 9.91022 15.6467 16.9338 -7.88269 11.4297 -3.43074 -290 2 10.0979 14.7902 16.532 6.40878 -6.10819 3.84543 -291 2 9.43747 15.4751 17.7557 1.6004 -7.26983 6.6271 -292 1 11.2148 8.51865 16.6243 -9.14606 -19.2231 -14.9185 -293 2 10.4285 8.06123 16.2547 13.8022 0.848227 5.21642 -294 2 11.6642 7.88268 17.1928 -1.33785 -0.880144 3.29074 -295 1 3.96477 18.2022 16.8388 0.151724 27.8243 14.0652 -296 2 4.47646 17.6367 17.4198 3.54357 -14.0579 0.0762873 -297 2 4.08749 0.446059 17.2373 -6.51294 -16.617 -15.0442 -298 1 2.23636 4.23466 8.90617 11.6474 4.96614 0.176633 -299 2 3.18727 4.06881 8.84702 -5.0902 0.586039 -2.82984 -300 2 2.03755 4.18072 9.84669 -2.61694 -5.47133 1.10155 -301 1 9.89683 10.3797 9.78633 12.6385 -21.4053 -24.2531 -302 2 9.49137 11.1552 9.42946 -10.1833 20.5571 -3.63947 -303 2 9.86232 10.3926 10.7266 0.554165 3.61624 28.8421 -304 1 9.72109 0.91625 10.832 13.6195 9.02414 1.59857 -305 2 9.21789 0.206273 11.2536 -3.38139 -4.49977 -6.76529 -306 2 9.17946 1.37162 10.1615 -3.40595 -8.11879 6.74876 -307 1 9.15707 15.1255 10.1914 20.6551 -3.22149 9.33909 -308 2 9.01609 15.916 9.68312 -8.41387 13.877 -8.61246 -309 2 8.34011 14.6408 10.1195 -14.233 -7.19689 -0.719266 -310 1 0.808146 9.70808 10.2086 23.84 -38.9856 -20.0319 -311 2 0.930598 10.6496 10.3444 5.65872 6.03362 4.8682 -312 2 1.64643 9.29884 9.83207 -32.5144 23.6532 16.8406 -313 1 17.0698 4.80337 8.05752 27.8638 -35.1931 -3.66362 -314 2 16.2966 5.30586 8.21629 -27.2809 18.9512 9.97555 -315 2 16.9993 3.9693 8.55928 -0.62818 15.8913 -5.61459 -316 1 14.8223 14.6574 0.153467 -11.4546 -14.4551 -9.90243 -317 2 15.436 15.0274 0.766448 14.8773 15.1477 17.5942 -318 2 14.121 14.2916 0.705806 -3.92817 0.026116 -2.07816 -319 1 3.85634 11.0156 9.57857 3.75671 2.20251 0.903354 -320 2 3.89754 11.3203 10.4983 -5.37308 2.01291 2.42961 -321 2 3.35837 11.6719 9.06911 -6.8083 1.73507 0.204751 -322 1 11.3728 10.7464 1.42992 33.2497 -4.81825 9.44885 -323 2 11.5281 11.6383 1.10055 0.915848 5.55374 -4.33141 -324 2 10.4426 10.6155 1.47257 -31.1398 -0.627116 -5.41705 -325 1 13.1828 7.20447 12.6676 -0.0478479 -14.2604 -0.4669 -326 2 14.1298 6.99811 12.5505 -7.76827 -0.67018 4.43892 -327 2 12.735 6.32848 12.7534 7.45412 15.7346 -2.47341 -328 1 9.63194 1.91441 0.890304 3.16134 4.31897 -8.70512 -329 2 8.77158 1.63222 0.526893 10.8452 7.48256 0.350857 -330 2 10.2032 2.19638 0.151243 -8.90992 -2.48069 6.74103 -331 1 10.6318 13.4626 4.55882 -11.5056 -1.99047 12.5083 -332 2 11.4876 13.0509 4.71851 7.47615 -1.29416 -2.63952 -333 2 10.4232 13.8662 5.41293 0.691023 4.41994 -1.81408 -334 1 14.5517 1.66181 10.9802 -11.5576 12.9 9.45395 -335 2 15.3776 1.3055 10.6442 8.04202 2.4344 -3.19562 -336 2 14.6907 2.6148 11.169 4.38713 -8.31284 -15.1855 -337 1 14.4901 12.0498 11.5809 -31.454 -4.77499 25.6083 -338 2 15.091 12.4736 11.0015 28.7023 12.1919 -21.8177 -339 2 13.8321 11.6274 11.0162 -1.74489 3.16984 -4.97875 -340 1 8.17369 5.13537 9.87952 -12.8505 7.96449 12.3464 -341 2 7.30162 5.126 10.3345 14.626 0.500686 -8.94194 -342 2 8.32701 4.24033 9.57061 -3.03583 -8.79147 -1.32617 -343 1 1.61182 16.9829 18.4557 19.3906 15.8485 -25.2691 -344 2 2.09739 17.4464 17.7224 -9.17701 -12.9822 18.3353 -345 2 1.80792 16.0477 18.3234 -0.14796 -4.92565 -1.79656 -346 1 1.43858 17.3769 15.3174 -8.9259 8.94647 7.52005 -347 2 1.45812 18.1702 15.9147 -6.93156 -15.9408 -17.1792 -348 2 0.507347 17.0882 15.1685 14.4449 8.30676 8.33907 -349 1 3.5257 5.78471 6.06613 -3.39677 -13.3058 1.89016 -350 2 2.9753 6.46227 6.46115 -3.38454 1.41808 7.55669 -351 2 4.15739 6.26663 5.53865 9.2569 4.30143 -12.1591 -352 1 12.629 9.51298 14.2604 -9.77978 19.3775 3.35531 -353 2 12.9437 8.76225 13.7938 15.2815 -22.6591 -22.819 -354 2 12.3447 9.10922 15.0729 -6.56341 1.36458 18.6396 -355 1 4.0928 15.2431 7.0497 -2.25109 -22.7738 13.7055 -356 2 3.66448 16.0653 6.81785 -2.80743 13.3283 -7.68 -357 2 5.04695 15.3859 7.01583 3.36741 6.66555 -6.63338 -358 1 0.780201 8.79903 15.0924 -4.1065 -28.223 6.26572 -359 2 0.548696 9.72105 15.1288 -1.34907 18.7642 -4.10325 -360 2 1.5752 8.72345 14.5481 -0.207921 7.22304 -3.82448 -361 1 12.9286 8.29499 10.1476 33.3114 -28.911 32.5654 -362 2 13.7554 7.80683 9.90421 -18.1809 10.2081 -7.43875 -363 2 12.9042 8.10572 11.1188 -9.83308 4.93442 -19.3471 -364 1 15.2998 7.93844 3.50826 -21.0939 -7.00262 -11.8412 -365 2 14.4558 7.58878 3.24395 -11.6977 10.4201 -28.099 -366 2 15.3831 7.3862 4.26257 30.2163 -1.92794 33.2483 -367 1 17.18 6.71526 18.6425 -0.133844 12.8911 -12.7702 -368 2 16.7451 5.93694 0.322596 -6.25651 -15.7248 7.28694 -369 2 16.4413 7.25778 18.3094 9.30548 1.37884 5.01187 -370 1 8.9084 6.99396 7.88573 -0.881002 2.32267 0.0260346 -371 2 9.83584 7.2627 7.79742 -0.0847644 -0.13812 3.11438 -372 2 8.83558 6.46246 8.69404 -0.0294368 0.694249 -1.22754 -373 1 12.437 0.501834 1.22358 -0.716997 -8.58934 -9.29719 -374 2 13.1312 1.05983 1.5788 8.89791 0.478791 5.50433 -375 2 12.732 0.307907 0.326573 -3.73597 1.67796 1.81541 -376 1 5.69458 15.0516 14.5143 3.69591 -14.2553 -4.53333 -377 2 4.76954 15.0969 14.776 -8.31751 1.66253 0.63197 -378 2 5.95328 15.9515 14.3109 5.80865 11.3045 -3.56535 -379 1 3.78081 6.42509 1.75203 4.2348 -8.30075 -4.29513 -380 2 3.33672 7.18396 1.37288 -3.60544 13.0853 -6.67388 -381 2 3.84967 6.63422 2.68491 0.545892 0.795555 6.86444 -382 1 3.88792 11.3989 12.3546 13.0971 -5.24635 -8.64578 -383 2 4.74838 11.8202 12.5261 -6.66532 -1.91753 0.168546 -384 2 3.23677 11.927 12.8169 -5.64663 9.70313 4.55872 -385 1 5.30252 3.85246 15.7701 3.45242 11.6571 4.53522 -386 2 6.06202 3.27771 15.61 2.30678 -4.65184 -5.35711 -387 2 5.68598 4.72788 15.9368 -2.89319 -4.23448 -3.12102 -388 1 14.1378 10.1309 4.62741 -6.40911 2.93718 -21.1253 -389 2 14.285 9.82325 5.50803 7.98673 -9.05047 24.7099 -390 2 14.6717 9.53242 4.07811 -2.84302 6.29722 1.17771 -391 1 7.65634 17.3346 9.10408 10.3132 -24.7491 -1.74792 -392 2 7.07794 17.6856 9.78277 -9.16436 8.21537 0.604828 -393 2 7.96278 18.0151 8.50473 -0.553145 15.1908 -4.94918 -394 1 4.52232 14.5173 3.95827 12.1345 -25.6108 -47.7046 -395 2 4.42958 15.3956 4.25649 -1.76895 36.8878 18.7873 -396 2 4.4098 13.9051 4.66351 -3.8607 -15.3504 25.5968 -397 1 14.1258 7.45828 15.8364 -6.23365 -6.73609 3.75314 -398 2 14.9302 7.39167 15.3277 7.57838 -0.290505 -5.08612 -399 2 14.4287 7.78058 16.69 -2.09073 5.34234 4.78248 -400 1 2.95098 18.3751 1.91859 -29.5535 -1.78839 -16.8987 -401 2 2.45071 17.8858 1.20736 17.1758 4.42604 21.0133 -402 2 2.2449 0.246547 2.36374 11.8246 -5.6794 -7.15496 -403 1 7.99154 1.5773 4.49846 30.6245 -5.45524 3.73918 -404 2 7.42382 1.97686 3.83614 -1.09908 5.00667 -8.45405 -405 2 8.90683 1.55308 4.13454 -22.7919 6.21994 3.05753 -406 1 2.44336 14.1732 17.7263 2.89693 8.8065 2.99283 -407 2 1.80182 13.5359 18.0713 -0.462046 0.279758 -5.24045 -408 2 3.30188 13.814 17.96 10.6791 -8.66055 4.12847 -409 1 0.94217 1.90899 13.8934 13.5408 -1.52741 -1.05885 -410 2 1.19747 1.57322 14.7589 -4.95142 3.16298 5.50662 -411 2 18.6373 2.03702 13.8998 -8.7871 -0.483879 -2.02084 -412 1 4.30938 0.151078 13.8855 7.43827 7.09651 -9.2822 -413 2 5.23906 18.5299 13.9426 -3.76642 -3.92995 -1.86801 -414 2 3.88869 18.4591 14.673 -3.49259 -4.03929 12.0029 -415 1 7.32054 0.93366 18.4163 -33.3446 -10.4004 5.92831 -416 2 7.32153 0.654144 17.4916 5.03052 -1.00997 0.0977128 -417 2 6.36163 0.937686 18.6972 26.0729 9.45288 -6.86634 -418 1 15.8933 18.4156 13.9169 -22.9956 8.12347 -47.8741 -419 2 14.9583 18.5802 13.6337 24.0447 -6.26997 16.1472 -420 2 15.9487 18.2637 14.8423 -3.56821 2.97357 29.888 -421 1 10.2651 4.57121 16.2688 1.93413 -35.0494 -13.7078 -422 2 11.2092 4.46181 16.4883 -7.31309 8.12251 -3.69007 -423 2 10.0229 3.6678 15.9192 2.49448 27.3645 14.4368 -424 1 15.9059 17.707 4.46041 -10.2591 -26.7612 -3.24664 -425 2 16.489 18.4443 4.44561 19.3223 26.1038 4.21423 -426 2 15.1093 18.0276 4.88994 -9.23113 3.77657 -1.20249 -427 1 6.91304 17.5561 13.9404 -32.5423 1.81832 8.8205 -428 2 7.45718 17.7359 14.6891 13.6263 3.56972 27.349 -429 2 7.55119 17.4736 13.2627 22.9256 -5.60471 -32.7019 -430 1 13.1887 6.46821 6.52506 2.14134 -6.99498 -16.9539 -431 2 14.1468 6.55272 6.36688 -10.1834 4.86047 2.66897 -432 2 12.7776 6.33144 5.63446 11.1073 4.86992 20.3892 -433 1 7.86929 2.3014 9.43186 -7.43999 -0.581733 -7.42672 -434 2 7.28758 2.26368 10.206 1.54253 -4.13193 1.23421 -435 2 7.37428 1.85692 8.71867 3.17855 7.90221 2.8646 -436 1 15.2039 14.7441 13.779 -1.62406 2.57688 -1.70285 -437 2 14.9354 14.9492 14.6806 -4.8726 3.09257 3.44485 -438 2 14.7582 15.3762 13.1995 0.661267 -3.02741 1.58802 -439 1 9.4149 8.38535 3.859 -25.1665 -10.991 -5.57318 -440 2 10.2049 8.88585 3.99067 20.2759 12.8236 2.22258 -441 2 9.67249 7.46496 3.96553 -1.56288 -2.67339 -2.00262 -442 1 17.7026 13.5834 16.4242 -1.80346 -11.0476 6.4727 -443 2 16.7549 13.3713 16.3986 -0.662501 7.25922 -2.44544 -444 2 17.8485 14.4294 15.9813 -4.13054 1.45271 -4.35383 -445 1 4.91191 10.5224 2.88074 35.1139 -21.7488 -13.7776 -446 2 5.74832 10.1175 3.20879 -18.1595 7.39309 -6.65206 -447 2 4.64711 11.0636 3.60968 -4.98951 12.9254 11.8317 -448 1 3.70989 8.40692 9.9178 -3.43098 -13.3807 16.77 -449 2 3.72102 9.34916 9.72654 3.49477 5.64054 -2.09668 -450 2 3.74613 8.34545 10.8924 -2.49133 1.09455 -12.0955 -451 1 15.9811 6.93645 5.90716 -9.64967 -5.56515 0.983492 -452 2 16.7246 7.40088 6.29715 7.31355 3.31596 3.21676 -453 2 16.2311 6.00551 5.84179 2.78737 3.87161 -3.53071 -454 1 15.2416 7.2288 8.97537 -25.1477 -13.3308 -14.4253 -455 2 15.9965 7.60799 9.37505 30.1105 10.4166 22.3283 -456 2 15.0439 7.80906 8.23828 -3.19363 1.15625 -6.55237 -457 1 6.20437 12.8345 12.7354 -14.1465 10.1654 -16.7884 -458 2 6.94522 12.3758 13.1101 18.4885 -10.5564 10.7987 -459 2 6.04629 13.6348 13.2503 2.66058 2.52169 8.79246 -460 1 12.1262 4.55048 13.1243 17.0811 13.049 12.1055 -461 2 12.3395 4.65477 14.0809 -9.37635 -6.07885 -14.152 -462 2 11.329 4.03313 13.0256 -8.31182 -5.5816 3.57791 -463 1 11.4354 8.07801 7.94226 -0.810806 3.70784 -8.7596 -464 2 12.2037 7.66847 7.47953 -11.1819 -0.00285319 12.9065 -465 2 11.6202 8.13058 8.89801 9.03316 -1.52538 -12.7532 -466 1 16.9943 10.8342 7.6109 -5.03955 -8.49642 17.9987 -467 2 17.7716 10.3123 7.42961 10.8043 -13.0503 -0.479497 -468 2 16.9113 11.4133 6.86596 -8.14606 13.8231 -19.3584 -469 1 5.21042 18.0585 10.7699 15.6232 7.92267 2.97831 -470 2 4.74775 17.5474 11.4283 -5.6196 -5.04348 5.46467 -471 2 4.57391 18.2408 10.077 -8.01525 -1.2934 -10.8517 -472 1 7.60043 17.4332 1.64042 6.79415 6.05281 -21.827 -473 2 7.93761 16.6332 1.20425 2.91062 0.230192 8.27204 -474 2 7.75711 18.1408 0.980897 -9.32049 -5.6032 10.0359 -475 1 1.93897 12.9382 13.63 3.13689 -3.11692 -16.6768 -476 2 1.43678 12.3217 14.1546 -10.1951 -7.38374 9.42459 -477 2 2.04891 13.7234 14.1672 6.66588 6.79896 5.37665 -478 1 9.3938 6.77683 14.8244 15.3217 -3.43003 -1.39025 -479 2 9.8639 6.00007 15.2423 -8.39432 15.0581 -15.9266 -480 2 9.75443 6.97816 13.9251 -4.83499 -14.7492 16.6004 -481 1 15.2802 4.37234 10.7612 17.1837 -0.598437 7.1821 -482 2 16.2442 4.23454 10.6079 -20.4209 -0.451849 5.19081 -483 2 15.2528 4.98337 11.5249 -0.66536 -5.42981 -12.7574 -484 1 11.4105 6.21551 0.0734026 -8.7314 7.93342 -2.27424 -485 2 11.3895 5.26963 0.0141504 12.2817 -18.3718 -0.889513 -486 2 10.499 6.41528 18.4856 -6.56297 9.87049 -0.998012 -487 1 18.513 11.4235 14.9225 12.9282 -22.681 3.72438 -488 2 17.9895 11.7369 14.1972 -5.90482 9.25399 -19.4183 -489 2 18.3571 12.0937 15.574 -0.537982 14.5307 17.0247 -490 1 7.08328 9.28085 7.30918 -19.7197 4.18214 5.56511 -491 2 6.73297 8.51044 7.78417 1.76821 -0.286333 -7.5509 -492 2 8.01676 9.1548 7.24802 24.3996 -5.081 -1.83944 -493 1 18.3255 15.3437 12.2137 -3.8694 0.735905 0.400418 -494 2 0.599616 15.5 11.9645 6.26195 2.32841 -0.363056 -495 2 17.7995 15.7522 11.5099 -2.40985 0.96637 0.371307 -496 1 16.511 4.37404 5.22763 -21.2214 -5.51878 25.3236 -497 2 16.4647 3.99489 6.12381 2.74309 1.28503 -9.80457 -498 2 17.4303 4.54035 5.0616 22.4703 -0.915278 -13.9933 -499 1 17.7218 3.13981 10.7749 -4.33552 13.9915 6.34554 -500 2 18.6231 3.34836 11.0663 1.21144 -2.68719 -3.11144 -501 2 17.734 2.28626 10.3485 2.99182 -14.4528 -5.38806 -502 1 12.2792 18.655 10.1327 17.2693 -45.8263 -15.1364 -503 2 11.5058 0.449575 10.4425 -26.2107 18.2097 8.79889 -504 2 13.0094 0.611642 10.1232 12.3896 24.8189 4.81349 -505 1 10.4214 9.73086 12.5154 -11.4047 -1.1898 4.78042 -506 2 11.1516 9.87418 13.1364 2.96428 -4.00819 -1.03044 -507 2 10.2474 8.77319 12.4992 9.30457 6.64045 -3.3636 -508 1 0.651598 2.68478 7.18172 -17.9134 21.5061 -11.8097 -509 2 0.347525 3.6016 7.34273 5.69642 -14.867 -2.54197 -510 2 0.849668 2.34638 8.05251 8.91351 -8.30419 8.52406 -511 1 0.318497 15.272 6.90444 -3.43175 -0.902574 -18.2314 -512 2 0.478582 15.5644 7.78858 6.40513 2.68345 23.4663 -513 2 0.623162 14.3599 6.89897 0.272636 -4.92753 -7.69196 -514 1 17.0533 6.94572 15.0273 7.81631 0.565766 -0.894277 -515 2 17.8128 7.55845 14.958 -6.36521 -5.11302 -0.197876 -516 2 17.4132 6.11744 15.3876 -1.58799 4.21551 0.905627 -517 1 9.15046 12.5368 8.00027 -36.358 14.0028 8.44058 -518 2 9.59383 11.9142 7.43445 3.21629 -19.4527 -15.2125 -519 2 8.22229 12.648 7.66907 25.8785 -7.47424 5.38289 -520 1 1.16102 1.67919 2.79298 -14.264 -19.5534 -4.4961 -521 2 1.06769 2.21394 1.99483 -1.93616 3.76767 1.09072 -522 2 1.84572 2.00753 3.35812 13.0572 19.5695 8.60311 -523 1 4.13351 15.1441 9.8761 6.18483 -5.86151 -6.61306 -524 2 3.91524 15.1965 8.93344 2.62784 3.42174 0.908977 -525 2 5.03514 14.7702 9.87632 -7.63961 1.62567 3.94135 -526 1 7.3909 2.2738 14.7748 9.28558 9.05007 -9.33433 -527 2 7.12441 1.5503 14.2057 -1.53405 -3.63662 -1.19206 -528 2 7.87829 2.88836 14.1809 -18.0097 -8.54319 17.0088 -529 1 18.3492 14.5565 2.15246 12.0934 24.362 7.12212 -530 2 0.551729 14.8667 2.53499 -6.69921 -6.84856 -6.85574 -531 2 17.7888 15.364 2.12839 1.3753 -15.6354 -3.85708 -532 1 10.0163 2.6808 12.9164 -0.493731 -5.11601 -9.40492 -533 2 9.92018 2.0572 12.1601 0.76191 10.4011 8.73608 -534 2 9.26265 3.29452 12.869 4.65507 -2.10266 -3.09911 -535 1 2.95427 8.9021 13.1034 24.5728 -3.04867 -5.91166 -536 2 3.51177 9.68096 12.817 -20.8286 -16.9148 9.19061 -537 2 3.59809 8.18481 13.2917 -7.73525 14.463 -2.49767 -538 1 3.26448 8.6069 3.78485 -10.2248 -21.121 34.5648 -539 2 3.76672 9.19042 3.24166 13.0731 20.305 -12.8555 -540 2 3.48359 8.83627 4.72374 -5.93153 -5.30867 -25.3462 -541 1 5.8473 7.24819 8.6208 2.3932 7.90906 9.86277 -542 2 5.81432 6.28497 8.53212 -5.5277 -2.57364 -0.635967 -543 2 5.0659 7.54439 9.12071 1.08185 -7.49096 -4.29671 -544 1 14.8764 1.57981 1.83846 12.2497 10.4795 -14.7641 -545 2 15.1104 2.2908 2.43504 -9.02026 1.90223 13.0204 -546 2 15.3525 1.8445 1.03212 -8.04537 -15.132 5.23431 -547 1 8.61698 15.0264 0.696156 7.89205 -2.64916 2.43147 -548 2 9.41092 14.8348 1.25307 -18.4618 8.30064 -5.38467 -549 2 7.89576 14.464 1.0316 3.03152 0.23278 2.41128 -550 1 15.4513 1.4301 7.20503 6.99627 -6.82188 0.69389 -551 2 14.8244 0.90582 6.69357 -2.8394 0.789398 0.0418873 -552 2 15.0149 2.26607 7.38205 -7.95005 6.31947 4.24803 -553 1 4.96675 12.927 18.445 -0.392058 -1.0762 11.0005 -554 2 5.34886 12.9244 0.695922 -4.30965 1.19363 -4.30526 -555 2 5.68 13.266 17.9034 2.74534 3.65082 -4.88489 -556 1 15.3953 8.66034 18.0902 -2.07624 -16.7815 -3.18775 -557 2 15.9144 9.19311 17.4724 -5.66293 4.97787 2.21077 -558 2 15.1583 9.22886 0.188985 2.48846 7.45062 3.31632 -559 1 12.0359 3.11648 18.28 -8.04977 7.84102 -5.19135 -560 2 12.2901 3.11968 0.565205 5.43673 -10.4163 -2.44039 -561 2 12.4787 2.41139 17.7764 2.20222 0.638625 8.9068 -562 1 13.1884 12.6911 5.14611 -2.25763 -6.31837 -0.123489 -563 2 13.4652 11.7849 4.90596 3.78769 10.9202 3.38983 -564 2 13.3386 12.7839 6.10454 1.74722 -2.69816 -5.37077 -565 1 6.12211 7.19464 0.152335 -0.889801 -16.5081 12.3486 -566 2 6.2475 8.12337 19.0248 -9.08967 1.02729 -5.81202 -567 2 5.35557 6.85974 0.666933 3.80599 9.00251 -10.0268 -568 1 17.6814 15.8746 14.896 -32.95 0.345881 -9.96463 -569 2 16.7135 15.9334 14.9982 15.4899 6.1636 11.5551 -570 2 17.7111 15.6936 13.9484 19.9419 -0.275145 -3.25111 -571 1 13.1284 0.88699 16.7751 -4.95458 6.20661 5.10718 -572 2 14.0638 0.660956 16.7688 7.30918 -0.228866 0.981928 -573 2 12.6898 18.6827 16.6682 -2.70263 -7.7996 -4.366 -574 1 10.8711 14.4993 7.46323 15.7126 -17.3597 -1.2585 -575 2 10.128 14.0173 7.85917 4.58757 6.56369 -3.56814 -576 2 11.6082 13.8461 7.48059 -10.4237 16.2655 0.791757 -577 1 17.6751 8.40087 2.13849 -13.7675 10.6042 3.42109 -578 2 16.7708 8.37025 2.51335 11.2555 0.423493 -3.0905 -579 2 17.6147 7.881 1.33167 1.95975 -7.58305 -2.5048 -580 1 12.424 7.82566 2.03348 6.80204 18.2298 -3.36389 -581 2 12.2928 8.74872 1.74157 -3.31877 -9.32949 5.70746 -582 2 11.9673 7.27395 1.39444 0.405274 -3.29714 -11.9602 -583 1 12.0088 14.6056 10.3972 49.4943 -15.6831 -19.0447 -584 2 12.4654 14.316 9.56616 -19.1829 7.51475 23.0356 -585 2 11.0956 14.6861 10.1978 -35.275 4.57666 -6.07844 -586 1 6.81054 6.90501 15.534 -24.6279 -1.31201 9.93627 -587 2 7.70831 7.14913 15.3109 11.0416 1.99651 0.427612 -588 2 6.48555 7.50951 16.2192 7.91049 -4.43387 -1.91407 -589 1 7.94039 4.47545 13.2332 14.4982 34.8647 21.806 -590 2 7.26408 4.6474 12.5684 -6.44209 3.92223 0.968251 -591 2 8.05746 5.34482 13.7439 -3.25809 -36.365 -21.9094 -592 1 13.3499 12.2014 14.3127 -1.24116 1.37617 13.1465 -593 2 13.3241 11.2332 14.3368 -6.04942 0.470969 -4.28371 -594 2 13.6308 12.4336 13.4212 3.90264 0.498209 -3.09495 -595 1 14.5954 9.45997 7.28998 13.2192 -1.86441 -1.0042 -596 2 15.4197 9.90762 7.5754 -11.2574 0.0534663 -4.99205 -597 2 13.8535 9.8793 7.72336 -3.17401 5.05716 8.17378 -598 1 12.6619 16.8656 3.26711 -0.0867316 -13.7478 -1.21165 -599 2 12.9036 17.3981 4.01825 1.80146 10.547 8.89773 -600 2 12.7645 17.4143 2.493 -0.0316456 12.4477 -7.66427 -601 1 1.00141 7.10091 17.3455 15.3286 -2.27437 -0.63111 -602 2 0.197357 6.73674 17.6796 -23.7065 -4.2556 16.6559 -603 2 0.696205 7.72166 16.6912 7.12828 11.4292 -16.7267 -604 1 12.984 4.84784 15.752 -30.1278 -7.6986 -1.85236 -605 2 13.773 4.32613 15.627 12.1969 -0.534485 4.03194 -606 2 13.2127 5.76882 15.785 16.3015 19.3583 1.60965 -607 1 2.35806 3.40155 5.13736 7.00458 -19.3644 -43.6846 -608 2 1.86996 2.9687 5.81855 -13.4119 -5.52905 24.958 -609 2 2.73401 4.18924 5.49805 8.9837 23.3098 13.0491 -610 1 8.19273 10.9521 13.6844 -8.81681 4.64201 23.2716 -611 2 8.19092 10.7627 14.6526 -0.424045 0.881441 -21.4162 -612 2 8.95149 10.4932 13.3231 15.2004 -1.23984 -4.72202 -613 1 13.0449 1.52469 13.2577 -17.2068 8.30684 11.3152 -614 2 13.5293 1.59874 12.4201 -3.55841 -0.219514 3.90721 -615 2 12.4208 2.28784 13.3343 18.9425 -17.4385 -9.09999 -616 1 6.61166 13.6023 2.12464 -9.14589 11.0627 -26.7302 -617 2 6.03511 14.0379 2.75872 -4.67031 1.02227 7.02539 -618 2 7.1693 13.0213 2.62577 8.97168 -8.12604 14.3361 -619 1 15.8326 6.37868 12.5447 13.0084 18.5244 20.7727 -620 2 16.3675 6.96965 11.9727 -5.6566 -10.5049 5.53461 -621 2 16.1589 6.56267 13.4684 -3.25982 -7.33208 -24.589 -622 1 16.7829 0.679169 9.53725 3.65315 -1.00951 10.2573 -623 2 16.653 18.4141 9.83094 1.34292 -7.75704 2.15353 -624 2 16.269 0.772043 8.73148 -3.87084 4.41009 -12.8197 -625 1 6.12871 11.643 8.2509 28.8456 37.0564 -10.7514 -626 2 5.32101 11.4251 8.67159 -25.2961 -16.2243 16.4685 -627 2 6.59615 10.8374 8.068 1.48557 -20.4229 -4.39625 -628 1 2.81588 8.6455 0.385911 -12.1168 -14.4708 -15.8933 -629 2 2.2408 8.27575 18.315 12.5525 5.70225 18.3425 -630 2 2.25296 9.2478 0.88122 -2.81952 5.7616 1.15354 -631 1 10.1112 10.3249 6.56463 -6.88185 10.2676 4.3595 -632 2 10.6724 9.72741 7.0699 2.3169 -7.24343 0.885556 -633 2 10.4905 10.3984 5.68005 1.7842 -2.70629 0.197339 -634 1 6.85117 15.7741 6.71172 -4.51814 -4.38518 8.0947 -635 2 7.10947 16.276 7.50071 -0.280141 -2.70051 -1.05147 -636 2 7.0022 16.3747 5.97143 2.95927 2.8361 -5.64101 -637 1 6.55245 12.8624 5.85582 3.66478 4.31955 2.99752 -638 2 6.71899 13.7301 6.24424 -0.933807 5.79026 -3.46681 -639 2 6.12481 12.3549 6.55179 0.263982 -0.200358 2.15574 -640 1 16.7435 12.5401 9.7846 -13.9618 -8.21713 16.7649 -641 2 16.8388 11.8663 9.10427 2.99064 0.578166 -4.74348 -642 2 17.1608 13.3339 9.48085 7.01955 11.3182 -8.14386 -643 1 6.27773 2.82725 2.7475 -16.1332 4.52919 -16.5002 -644 2 6.37029 3.76301 2.48637 6.52487 -6.75351 6.59876 -645 2 5.7241 2.45518 2.0296 8.37538 -0.331655 9.00677 -646 1 10.7419 2.97566 3.2545 -3.93098 2.36946 -8.35386 -647 2 10.3631 3.83794 3.45313 -5.44824 -1.84651 0.91029 -648 2 10.2755 2.65841 2.45654 4.06882 -1.04864 5.83378 -ITEM: TIMESTEP -90 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.80968 6.6261 17.8375 -14.5778 0.995444 8.41947 -2 2 7.95772 6.60642 18.3334 15.3437 1.8775 -14.2431 -3 2 8.74654 5.99095 17.1112 1.57504 -1.57025 6.7209 -4 1 0.142832 8.36014 6.73441 10.0116 -15.4349 27.0014 -5 2 0.232649 8.20449 5.79462 4.11725 -7.32768 -11.6468 -6 2 0.67494 7.65251 7.20998 -18.6261 25.5606 -16.1468 -7 1 8.65703 0.380136 6.98192 16.3005 -1.0776 2.50655 -8 2 9.57515 0.309779 6.66722 -10.0942 0.994659 4.05519 -9 2 8.27212 1.03395 6.395 -6.58679 0.322126 -3.42087 -10 1 6.47941 1.69165 11.7468 2.00503 -21.4393 -6.03474 -11 2 5.9725 2.29393 12.2744 -13.1143 10.2157 7.12378 -12 2 5.89376 0.920881 11.5936 7.71629 6.15291 -2.33076 -13 1 6.9103 5.50063 2.38437 -35.7814 23.4203 2.69428 -14 2 6.20944 5.92743 2.96221 29.3961 -15.7919 -7.47581 -15 2 6.73166 5.94071 1.53167 10.6635 -7.16691 8.95661 -16 1 16.211 10.2361 16.1124 -22.7966 -2.93172 13.0323 -17 2 16.937 10.2632 15.5246 28.6916 5.0146 -15.8412 -18 2 15.9737 11.152 16.3021 -3.36115 -0.429235 -4.16748 -19 1 10.8196 14.9788 2.33309 -6.31813 -9.42536 4.48609 -20 2 10.7437 14.525 3.19227 -2.25161 -0.175376 -6.3843 -21 2 11.168 15.8375 2.56675 6.6431 8.63317 3.56201 -22 1 17.1655 8.21466 10.9616 20.3007 -11.9207 -19.649 -23 2 16.6876 8.89778 11.4174 -14.8371 14.2918 8.905 -24 2 17.9353 8.67496 10.5709 -5.82559 -3.7293 4.59063 -25 1 14.5981 15.9748 16.3536 13.4587 -18.0704 19.8012 -26 2 13.6875 16.2688 16.3636 -10.2246 8.72504 -7.33216 -27 2 14.6733 15.4751 17.2031 2.63957 5.2712 -15.5493 -28 1 12.1292 13.2811 0.580093 14.6523 -12.0599 13.1814 -29 2 11.875 13.3883 18.3092 -10.372 6.98394 -12.7652 -30 2 11.639 13.8901 1.1449 -2.74566 6.59249 -3.74219 -31 1 9.34925 5.48981 3.82539 12.3818 -0.191077 28.8485 -32 2 8.80634 5.44704 4.61652 7.17551 -1.92534 15.5524 -33 2 8.65833 5.42982 3.20736 -26.4153 -0.989629 -43.3837 -34 1 1.57757 3.9189 11.5719 -21.368 33.8782 -18.8992 -35 2 1.50486 4.82423 11.9434 2.77 -7.29772 -4.79385 -36 2 1.95891 3.38097 12.2317 20.2106 -22.0339 29.781 -37 1 2.11583 6.92705 8.12278 -10.2704 -2.23476 -15.4196 -38 2 2.47676 7.42607 8.85663 6.65774 -1.70501 8.2798 -39 2 2.06913 5.99576 8.38149 2.03129 -2.32531 8.57063 -40 1 5.2846 4.43559 7.83749 -11.1092 26.0267 -7.92074 -41 2 5.42959 3.50305 7.74019 3.58921 -20.4287 3.63869 -42 2 4.59753 4.67739 7.1831 9.16507 -0.464339 6.41033 -43 1 3.36483 2.87842 17.4354 -5.48754 -0.0293267 11.8999 -44 2 4.0122 3.13798 16.7945 16.5223 13.9802 -16.1706 -45 2 2.91387 3.69111 17.7275 -1.08839 -5.27878 2.29607 -46 1 7.51128 5.54904 6.16479 9.71808 2.6671 3.00483 -47 2 8.12131 6.08033 6.71556 -9.69992 -1.44216 -4.10694 -48 2 7.04033 4.98631 6.78947 -1.48399 -2.17988 -0.0590646 -49 1 9.79239 7.0023 12.0333 -12.7203 -1.67256 -9.54047 -50 2 10.0574 6.1295 11.7028 -2.54946 7.94968 0.438659 -51 2 9.0334 7.28866 11.4661 15.1177 -5.87574 8.09476 -52 1 14.1269 3.84395 8.13857 -24.8841 12.3935 -19.8999 -53 2 13.4363 4.47719 7.80064 24.2741 -16.3277 6.83338 -54 2 14.3749 4.15432 9.00462 4.04893 6.4318 14.0535 -55 1 4.52686 17.2232 3.85531 -7.09571 -9.71268 16.0786 -56 2 5.35353 17.6803 4.02689 3.89364 6.28665 -2.88462 -57 2 3.96567 17.7155 3.24673 4.45666 4.6431 -9.26961 -58 1 16.1958 16.5107 10.5377 18.4287 -13.9772 -31.1199 -59 2 15.4454 16.6557 11.0933 -16.6117 1.05393 13.9092 -60 2 15.8645 15.9242 9.81336 4.55855 15.7974 16.2758 -61 1 1.967 4.85121 0.0645769 9.40837 -19.0171 0.778776 -62 2 2.73793 5.10942 0.56616 3.15966 4.76786 17.0447 -63 2 1.80075 5.61055 18.1709 -12.801 18.3624 -15.2179 -64 1 11.1737 13.314 16.4367 2.74473 1.78814 5.72217 -65 2 10.7128 12.4641 16.5748 8.32361 2.87799 -7.58216 -66 2 11.8417 13.1969 15.7431 -5.18043 -7.14508 -0.417807 -67 1 10.0458 10.8999 16.8205 33.4394 -5.51473 9.19041 -68 2 10.5428 10.0531 16.9406 -15.1708 22.1127 -3.77119 -69 2 9.12902 10.6892 16.7607 -22.7906 -6.8787 -3.44008 -70 1 11.889 17.5084 13.4814 3.48745 6.24304 -13.0003 -71 2 12.5913 17.1622 12.8998 -9.91022 -4.16273 6.93206 -72 2 12.0139 18.4633 13.4204 2.43964 2.21886 2.73389 -73 1 6.44228 9.49569 12.2996 9.71147 -12.8692 -34.1322 -74 2 7.06965 9.17025 11.5988 -17.7592 6.4035 17.1392 -75 2 6.97144 10.0526 12.8659 4.91959 6.23922 4.73193 -76 1 16.3022 12.832 2.75135 -12.5209 9.65366 -4.24277 -77 2 17.1598 13.1655 2.44684 -4.70434 0.462679 5.46936 -78 2 15.6996 13.6248 2.74248 12.9928 -20.5688 3.1232 -79 1 0.706696 12.7395 5.83755 -10.6776 2.47735 15.1944 -80 2 1.02688 12.9731 4.95908 -4.07327 -10.4263 -9.29508 -81 2 18.3891 12.5308 5.80039 14.5368 6.4085 -10.1514 -82 1 5.29875 16.3254 18.4501 12.7507 -5.44046 -6.67673 -83 2 5.72604 15.6129 17.9385 -8.69196 7.59677 5.8406 -84 2 6.01274 16.6418 0.375909 -8.3334 1.51688 4.30584 -85 1 0.743878 7.68205 4.10167 -26.7478 -30.2572 33.4946 -86 2 0.179417 7.92019 3.37827 -7.5716 9.21403 -16.4097 -87 2 1.60385 7.98113 3.89879 36.269 17.899 -12.2731 -88 1 3.22103 9.09598 6.53924 -28.7289 15.6764 -27.4701 -89 2 3.63534 8.61301 7.2251 9.03881 -15.9481 23.3571 -90 2 2.25678 8.88215 6.53178 21.3431 5.76786 5.41461 -91 1 7.2773 10.3926 16.241 -1.60955 -9.9776 11.4431 -92 2 6.63502 11.108 16.2935 -0.090439 -0.440245 3.15105 -93 2 7.09074 9.80627 16.9963 -3.87073 10.8392 -3.46734 -94 1 11.0095 0.891279 5.03438 2.23591 -17.8064 16.3849 -95 2 10.8775 1.7336 4.57918 5.69275 -3.07397 -7.72854 -96 2 10.7003 0.188666 4.43596 -0.931337 13.9517 -3.17827 -97 1 4.21583 2.94335 13.1635 9.62289 2.41259 16.4284 -98 2 4.47922 3.3428 14.0131 -5.18172 -0.255184 -10.0037 -99 2 4.1364 2.00091 13.3783 -2.2119 -1.88246 -4.82143 -100 1 8.45625 10.2801 1.81127 9.01648 -22.0588 9.24648 -101 2 8.30671 10.8697 2.54783 -2.77767 16.2884 7.52121 -102 2 8.66335 9.4444 2.27657 -0.852681 8.00384 -10.6723 -103 1 10.2261 1.659 15.4538 -6.06042 8.31352 -11.6288 -104 2 11.1361 1.48308 15.6359 20.1952 -3.56794 7.64131 -105 2 10.2187 1.98601 14.5369 -5.79366 -2.30068 5.3707 -106 1 2.60435 12.742 7.94637 -6.15341 0.568057 0.983218 -107 2 3.03975 13.5699 7.72118 6.64853 3.0435 -2.79803 -108 2 1.95513 12.6117 7.24141 1.86204 -3.09485 1.26562 -109 1 3.88579 11.7956 5.01149 -19.6155 -13.0634 1.96641 -110 2 3.74363 11.1082 5.69355 0.727972 11.568 -8.07528 -111 2 3.05901 11.8342 4.47209 17.5209 1.69759 11.0979 -112 1 6.76239 14.55 16.9383 -0.403452 -2.75277 4.08609 -113 2 7.61561 14.9826 17.0312 2.52456 -1.29817 -0.221044 -114 2 6.44911 14.7692 16.0549 2.09428 -3.60588 -3.74869 -115 1 14.1942 14.5231 3.16652 -5.12336 -14.4242 4.12891 -116 2 13.6899 15.3256 3.31261 0.149267 9.23779 -5.23449 -117 2 13.7696 13.8761 3.7521 4.09464 2.97302 0.255936 -118 1 8.7401 18.0877 16.1157 -15.0544 -15.1521 5.72203 -119 2 9.42706 17.4939 16.3945 -6.08837 -23.732 7.70311 -120 2 9.27218 0.11536 15.7481 8.35971 40.209 -14.9349 -121 1 4.63391 1.71898 4.89 36.0507 -5.82478 -13.0459 -122 2 3.81997 2.19927 4.85319 -16.3674 13.8452 0.00946397 -123 2 5.20292 2.04685 4.14723 -16.8402 -3.94878 19.5369 -124 1 15.0105 12.65 16.5031 22.0082 2.89039 39.0948 -125 2 14.6032 12.5883 17.4132 0.919275 4.87615 -33.2046 -126 2 14.3966 12.5461 15.7793 -22.8851 -3.84554 -8.75239 -127 1 15.7197 18.424 16.8504 13.0838 27.0964 8.25258 -128 2 16.3964 18.519 17.5419 -1.36847 2.51381 -4.544 -129 2 15.6686 17.4972 16.714 -13.5977 -31.6712 -2.03374 -130 1 1.39308 1.32386 16.6798 -9.07755 4.26299 3.83254 -131 2 2.19455 1.8573 16.8358 -13.1892 -10.0845 0.867767 -132 2 0.760663 1.62622 17.366 11.6728 -4.82483 -8.86289 -133 1 18.2416 4.3099 15.966 -4.36834 -5.16176 -14.6355 -134 2 17.7783 3.61219 15.465 8.57404 10.6893 6.25867 -135 2 0.425079 4.50442 15.5034 -5.04787 -4.14191 4.79432 -136 1 12.0688 17.0582 16.1192 -6.60497 -5.44285 54.7429 -137 2 11.374 16.6436 16.7154 18.2098 8.22439 -32.524 -138 2 11.7541 17.1189 15.223 -7.97888 -4.44492 -17.7493 -139 1 16.0987 2.72798 18.2222 -6.94033 2.52412 -3.34156 -140 2 15.6657 3.49187 18.6187 5.88163 2.98889 4.51464 -141 2 15.8079 2.8031 17.3159 -2.77048 -8.0731 -14.4365 -142 1 6.58612 13.762 10.0351 1.63352 -0.32404 13.73 -143 2 6.39624 13.3299 10.8846 2.34483 4.77487 -0.634471 -144 2 6.55421 13.0562 9.39028 1.369 -6.64332 -8.7831 -145 1 10.1169 18.5721 2.70869 27.9004 -1.02691 -4.20355 -146 2 10.7561 0.140951 1.98734 -15.1054 -0.137902 13.7961 -147 2 9.28626 18.3596 2.30468 -14.2521 -4.05351 -7.65243 -148 1 3.07988 17.6804 6.1902 -35.1734 2.13391 -17.3705 -149 2 2.15682 17.7525 5.8242 24.0448 -4.32039 20.662 -150 2 3.55195 17.7661 5.36197 20.4585 -2.58277 -0.69289 -151 1 12.6061 16.7775 7.89366 1.16584 -8.73771 -17.6522 -152 2 11.856 16.1922 7.7211 -0.763759 -4.24653 -1.89641 -153 2 12.3057 17.3353 8.59898 -2.13454 17.8975 18.5826 -154 1 14.8965 15.3132 8.35277 -22.4274 15.9599 0.214205 -155 2 14.2421 15.9941 8.02515 16.4945 -20.4059 13.6979 -156 2 15.4898 15.1572 7.61828 5.37632 7.31151 -11.1374 -157 1 17.8957 18.2766 0.201476 9.69326 -17.5267 -0.973127 -158 2 18.6995 17.7195 18.781 -12.0492 3.04369 -7.3597 -159 2 18.2321 0.401263 0.645934 -1.5685 17.2308 6.22008 -160 1 0.802158 10.4818 1.45184 -19.0828 -29.4994 30.4216 -161 2 -0.0309651 10.0246 1.77565 29.2477 9.1244 -14.7118 -162 2 0.53478 11.1455 0.834437 -7.87366 18.9841 -18.3051 -163 1 1.85308 12.2863 3.27351 -7.97315 5.10175 -10.2215 -164 2 1.42551 11.5849 2.74616 7.16023 4.54594 2.45335 -165 2 2.09673 12.9814 2.63054 -3.38314 -5.43944 9.55244 -166 1 0.718881 17.2977 4.9616 -19.2906 6.0419 1.76293 -167 2 -0.10575 17.7685 5.12875 8.39755 13.2462 -10.2288 -168 2 0.622971 16.5645 5.55208 6.7728 -21.2776 10.1703 -169 1 1.03867 0.919889 9.35844 3.74022 -6.32288 33.4729 -170 2 1.10918 0.592533 10.3007 6.31379 11.0803 -22.721 -171 2 0.269914 0.464458 9.03134 -8.6906 -2.38217 -7.04515 -172 1 16.7862 2.42581 13.3986 14.7457 27.0937 -15.311 -173 2 16.9847 2.74906 12.4891 -5.29709 -2.40963 18.2684 -174 2 16.5429 1.52129 13.2791 -8.06021 -27.7395 3.47759 -175 1 2.69738 16.0066 12.0777 13.1506 -14.7233 12.6976 -176 2 3.02715 15.5922 12.9029 -9.51867 9.47826 -13.4594 -177 2 3.28974 15.6737 11.3809 -2.31502 2.53439 -1.78657 -178 1 16.3754 15.4917 6.11201 -7.25585 -20.1131 3.67265 -179 2 17.3156 15.5044 6.29369 9.86882 2.22778 5.36532 -180 2 16.2073 16.2228 5.51797 -0.959992 10.1027 -9.31738 -181 1 5.7174 5.24337 11.7813 4.42707 -14.1004 -1.48072 -182 2 5.44277 5.99707 12.328 1.64183 -4.11158 -2.88134 -183 2 5.22325 4.47043 12.1002 -4.92771 7.03451 -4.06757 -184 1 15.1242 4.92712 0.766674 18.5408 -12.9138 10.3204 -185 2 14.9855 4.62556 1.67944 -3.08744 4.9541 4.0864 -186 2 14.3291 5.35182 0.492873 -21.4444 10.4963 -5.72763 -187 1 16.3798 16.4926 1.83048 25.9496 20.3657 -34.7081 -188 2 16.3432 16.8093 2.72897 -9.33108 7.61853 14.7037 -189 2 16.7914 17.2408 1.28765 -16.0156 -28.1785 20.3541 -190 1 0.157471 4.87182 3.99278 -9.81132 22.7056 -3.03191 -191 2 0.5332 5.76253 4.03054 -8.2904 5.08609 0.673103 -192 2 0.911036 4.31937 4.01308 22.6258 -22.4944 4.73784 -193 1 2.97603 15.0857 15.1688 -3.76699 16.0764 -9.28303 -194 2 2.87698 14.8354 16.0845 -1.20729 -14.2266 12.1787 -195 2 2.48786 15.9266 15.1702 1.40562 1.39337 -6.33902 -196 1 1.10637 14.6846 9.51596 31.8836 22.2572 14.4694 -197 2 2.01065 14.9183 9.89233 -34.4229 -12.9306 -18.6629 -198 2 1.03031 13.7317 9.56194 1.94445 -7.79278 4.16037 -199 1 13.55 16.5172 11.5597 10.1041 14.0808 -3.72584 -200 2 13.3442 17.2549 10.9555 -5.19335 -6.01443 7.16005 -201 2 13.1025 15.7566 11.183 -9.96101 -8.306 -1.961 -202 1 4.75563 1.55237 0.702796 10.3802 -26.0161 11.0265 -203 2 4.32304 2.05314 0.014379 -14.7339 5.42124 -2.63334 -204 2 4.14265 0.839056 1.00315 4.15161 14.819 -1.07901 -205 1 1.52656 18.6416 11.9009 -8.95117 16.8483 13.4998 -206 2 1.43825 0.48402 12.7573 3.56637 -8.71242 -18.201 -207 2 1.98334 17.8196 12.0914 3.68072 -6.34965 2.55122 -208 1 11.4393 10.1383 4.17836 -13.7636 4.05009 -8.78245 -209 2 11.3903 10.5027 3.28707 -1.50281 2.58284 -2.63304 -210 2 12.3655 9.96172 4.28712 17.4192 -2.53267 8.67839 -211 1 8.18359 12.1636 3.86104 -21.222 -14.272 -14.5003 -212 2 9.05859 12.5239 4.0446 -0.40723 6.23371 14.3883 -213 2 7.56046 12.2135 4.62832 23.1203 4.46306 -6.77507 -214 1 14.593 4.04535 3.38111 7.28555 -5.40785 -19.1504 -215 2 15.2127 4.15408 4.10794 5.52844 2.67895 3.03112 -216 2 13.7536 4.35259 3.70606 -13.9578 6.65801 6.31365 -217 1 5.72323 1.65443 7.61073 34.4 15.7962 37.2038 -218 2 5.13785 1.03104 8.01585 -19.7408 -11.9782 7.15973 -219 2 5.42676 1.78462 6.74294 -17.7695 -4.7826 -52.6001 -220 1 17.8873 1.06414 4.83181 6.8154 -0.232455 -4.71432 -221 2 18.4369 1.21178 4.04718 -2.79964 -1.76243 2.38037 -222 2 18.3376 1.55744 5.53048 -5.83965 -0.882229 4.9581 -223 1 6.85055 9.23648 4.54341 6.32277 -8.10519 -4.82585 -224 2 6.75809 9.38079 5.49182 3.88959 4.29486 1.07151 -225 2 7.79379 9.02149 4.39148 -10.7358 1.98669 4.12637 -226 1 2.55801 14.782 2.06648 -8.35029 -12.2797 -25.7867 -227 2 3.24533 14.7191 2.71695 15.3489 0.778658 13.055 -228 2 2.98421 14.5338 1.22242 -9.03529 10.4097 12.3511 -229 1 17.2667 12.9721 13.1114 -20.9369 36.2303 -2.57416 -230 2 16.4188 13.4451 13.3365 18.5804 -22.1292 -0.415694 -231 2 17.7749 13.7311 12.7641 -0.529191 -13.9074 0.965338 -232 1 14.8416 10.5583 1.56689 -2.78575 22.6182 14.2458 -233 2 15.4799 11.2066 1.96334 -16.8252 -10.4846 -9.71145 -234 2 13.9405 10.9259 1.71943 20.5685 -8.6057 -5.43477 -235 1 5.6352 6.7176 4.51351 -9.14706 -11.8638 3.15016 -236 2 6.0003 7.60062 4.53525 2.53301 15.852 -6.04122 -237 2 6.16933 6.24394 5.16122 6.25334 -1.18144 -1.3834 -238 1 8.0084 8.26626 10.2701 -4.49752 14.9075 -15.7864 -239 2 8.53054 8.9292 9.77232 -0.437986 -11.1673 11.0277 -240 2 7.35426 7.95022 9.61336 5.97292 -3.64509 13.4454 -241 1 13.4616 18.4657 5.71166 17.1322 -6.35165 -5.45305 -242 2 12.613 0.202175 5.51075 -18.0122 19.0124 -5.00284 -243 2 13.2587 17.813 6.37409 -3.85709 -10.1746 14.3256 -244 1 0.0252945 2.56986 0.408061 0.439602 -5.22175 -5.84652 -245 2 17.7844 2.56336 0.0359587 -11.4993 -5.28871 3.98864 -246 2 0.277142 3.47535 0.26454 16.627 13.7372 -0.461998 -247 1 12.8639 10.8267 9.72576 -55.6075 31.3565 -11.278 -248 2 11.8723 10.9451 9.72713 30.8534 7.0313 -2.47663 -249 2 12.8724 9.89108 9.83244 20.4971 -22.7651 5.79467 -250 1 0.607625 12.2828 11.1117 24.514 -2.72666 -9.78403 -251 2 18.2964 12.3126 11.1603 -11.5713 5.22338 7.13378 -252 2 1.01642 12.6716 11.9034 -8.98148 -2.79725 -0.830812 -253 1 5.29539 7.3549 13.3064 -7.85772 10.5518 3.63543 -254 2 5.70599 8.16396 12.9287 -0.549664 -12.4206 10.9242 -255 2 5.67568 7.22584 14.1948 2.69835 3.31529 -9.72444 -256 1 1.17555 6.77844 11.9244 -33.9372 -12.3631 -14.3141 -257 2 0.259637 6.99751 11.6106 25.929 -3.06653 9.08527 -258 2 1.58097 7.60434 12.1643 7.59492 14.5493 8.35248 -259 1 15.5141 9.76806 12.4302 -1.8656 17.4266 8.04916 -260 2 15.0855 10.6363 12.2204 12.2826 -22.7347 2.36453 -261 2 16.0019 9.91808 13.2494 -6.58523 -0.731675 -3.13373 -262 1 16.4968 12.5534 5.50851 9.37615 -29.7593 -4.66799 -263 2 16.3074 13.4744 5.68685 -5.44524 15.7433 -9.11055 -264 2 16.3732 12.3531 4.54775 0.322938 17.9758 14.7603 -265 1 6.32376 9.8903 0.169934 -28.7401 -0.365509 -5.18995 -266 2 5.50824 10.2805 0.557378 14.6251 -5.00462 -6.15541 -267 2 7.04833 10.2225 0.694867 12.727 0.898893 11.9262 -268 1 12.1515 6.04661 4.01259 -24.0177 -36.8905 11.864 -269 2 12.231 6.67099 3.30768 1.42994 18.9462 -13.2923 -270 2 11.2548 5.64061 3.89367 21.868 15.3866 4.7403 -271 1 0.316109 12.8908 0.0158726 1.97018 -1.90411 4.82087 -272 2 18.784 13.4984 0.752127 -2.36898 -0.989285 -3.79 -273 2 18.4247 13.2164 17.9164 2.23727 -3.47257 5.47524 -274 1 3.55093 0.0615484 8.6771 30.4928 -5.90286 -4.02028 -275 2 3.49841 18.2151 7.84215 -7.8476 4.22576 -1.41638 -276 2 2.7473 0.557235 8.76228 -21.0031 4.54937 0.225707 -277 1 7.3901 17.5352 4.48573 6.23592 32.7201 -14.6481 -278 2 7.69571 18.4853 4.57976 -11.8279 -33.7706 3.32686 -279 2 7.33788 17.4402 3.51852 2.74261 -6.71083 9.2357 -280 1 9.25 17.16 12.2333 -3.7288 14.5824 3.61249 -281 2 9.26512 16.5009 11.5521 -3.80961 -18.6559 -12.0666 -282 2 10.1634 17.2094 12.5273 3.6148 1.53928 10.2644 -283 1 13.402 13.1082 7.90091 0.220655 -14.9059 29.302 -284 2 13.4302 12.436 8.64233 -5.21958 14.4877 -25.9571 -285 2 13.929 13.8525 8.23076 3.39805 -3.2421 -4.10773 -286 1 14.8025 2.90677 15.4495 23.2091 4.40575 2.70159 -287 2 14.1483 2.29946 15.1328 -14.8482 -16.0174 -4.02081 -288 2 15.4935 2.87296 14.7763 0.208871 3.12507 -3.30872 -289 1 9.90762 15.6519 16.9195 -4.56731 4.54647 -2.1455 -290 2 10.1638 14.7845 16.5964 9.48907 -4.21512 -5.5698 -291 2 9.51082 15.4442 17.7618 -6.39245 0.962418 13.4848 -292 1 11.1953 8.50068 16.6178 -6.68582 -9.72424 -8.69684 -293 2 10.4052 8.01271 16.3331 5.65618 1.52157 -2.37675 -294 2 11.7201 7.85843 17.0918 5.14472 -5.56789 7.7477 -295 1 3.97964 18.2216 16.8609 -11.5365 11.132 -5.80894 -296 2 4.44261 17.5481 17.3724 7.79342 1.98205 9.06349 -297 2 4.16759 0.471834 17.2017 1.31413 -17.4358 -0.663005 -298 1 2.27286 4.25928 8.9046 8.30035 -0.830932 12.3077 -299 2 3.22373 4.0264 8.87035 -15.4899 4.40379 3.11293 -300 2 1.97207 4.14495 9.83591 10.7423 -1.42059 -17.2737 -301 1 9.92348 10.3926 9.8203 -1.21029 -1.85278 -24.2235 -302 2 9.36782 11.1029 9.49607 0.630055 7.16446 -2.16893 -303 2 9.82869 10.3844 10.7566 4.49005 -1.30636 29.4196 -304 1 9.77911 0.915187 10.8241 -1.58049 4.53496 -1.50662 -305 2 9.30516 0.126632 11.1017 -0.152878 -7.87834 6.94802 -306 2 9.15539 1.38664 10.2518 4.51752 0.176684 -4.82426 -307 1 9.1489 15.1729 10.179 6.96198 -6.50551 5.53221 -308 2 8.91001 15.8322 9.53904 -4.06695 15.478 -9.20984 -309 2 8.38415 14.5913 10.1616 -4.75674 -5.76082 4.02117 -310 1 0.743465 9.68917 10.1631 30.9903 9.57445 -5.37239 -311 2 0.884314 10.6156 10.4664 -8.35327 -15.1374 -2.2352 -312 2 1.62506 9.41264 9.82336 -24.2866 3.90606 7.18729 -313 1 17.1113 4.7779 8.02102 2.26389 -23.2748 8.45538 -314 2 16.3418 5.309 8.21811 -5.84575 9.78705 2.38191 -315 2 17.0463 3.99595 8.60382 3.74785 14.695 -9.14029 -316 1 14.847 14.6269 0.171171 -19.7527 -14.4968 -14.2937 -317 2 15.5321 14.9161 0.755334 10.0132 13.2257 15.972 -318 2 14.1228 14.2968 0.729437 5.50655 3.69994 -2.14986 -319 1 3.90456 11.0507 9.5998 -4.69832 -0.998696 -0.0493525 -320 2 3.86255 11.1688 10.552 1.28841 5.10968 9.84865 -321 2 3.27063 11.6917 9.24194 0.0177884 -1.71993 -8.82733 -322 1 11.433 10.7439 1.41897 29.5023 2.97313 10.7876 -323 2 11.6019 11.6536 1.12948 3.85703 -2.03295 -2.25776 -324 2 10.504 10.6413 1.35913 -35.0433 -4.68689 -6.35229 -325 1 13.1835 7.21214 12.6412 -8.23521 -20.1104 -3.47812 -326 2 14.127 7.05932 12.5127 3.33109 -0.638199 4.03042 -327 2 12.8061 6.29857 12.6985 3.22225 19.9882 2.50286 -328 1 9.65928 1.95745 0.843925 10.2182 6.36996 -3.06277 -329 2 8.81763 1.63483 0.51897 -5.65357 2.11518 2.03686 -330 2 10.1334 2.26536 0.0610097 2.29468 0.231167 4.03759 -331 1 10.5974 13.4461 4.57973 -2.39764 -3.17335 8.92217 -332 2 11.4415 12.9723 4.66721 0.170993 3.79528 3.71784 -333 2 10.3828 13.7711 5.47244 5.6647 1.39651 -7.04866 -334 1 14.5805 1.64306 10.9903 3.01891 29.9103 -7.34195 -335 2 15.4206 1.31489 10.661 2.43812 -13.4824 -3.17866 -336 2 14.6923 2.61327 10.8523 -8.77415 -13.7688 6.87151 -337 1 14.4577 12.0498 11.5485 -29.7481 -1.24334 12.4997 -338 2 15.1787 12.3182 10.9897 13.6492 5.38623 -14.4259 -339 2 13.7324 11.7114 10.9784 17.3586 4.51945 3.50834 -340 1 8.16823 5.15587 9.894 -28.9634 21.8059 19.126 -341 2 7.25961 5.26999 10.2972 28.5921 -4.04796 -11.5402 -342 2 8.23961 4.23455 9.67377 -1.01689 -19.4985 -4.69706 -343 1 1.66839 17.0027 18.4477 20.9596 26.331 -27.2012 -344 2 2.19503 17.5247 17.7665 -16.8758 -18.2972 22.1195 -345 2 1.83767 16.0826 18.2308 2.67698 -10.8321 1.22526 -346 1 1.40907 17.4029 15.3161 -1.8056 14.8407 8.29727 -347 2 1.4134 18.2156 15.8633 3.96238 -8.68525 -7.97287 -348 2 0.471831 17.1989 15.2085 1.34275 -7.61847 -1.46046 -349 1 3.49459 5.75594 6.06077 -10.0958 -15.2551 6.44531 -350 2 3.00844 6.4276 6.56158 3.56089 -0.0685925 -1.76679 -351 2 4.03572 6.19023 5.40706 10.0519 13.1926 -8.23224 -352 1 12.6765 9.5142 14.2706 -5.75697 27.7722 -14.2581 -353 2 13.0673 8.79775 13.7668 1.15853 -14.5514 3.26719 -354 2 12.382 9.20431 15.1249 -1.95515 -14.6959 8.85488 -355 1 4.11243 15.2112 7.12768 13.4261 4.57048 -4.21166 -356 2 3.68336 15.9917 6.77855 -13.243 7.84695 -2.74865 -357 2 5.05149 15.4218 6.9541 -4.34911 -9.58911 5.5273 -358 1 0.807347 8.85082 15.1137 12.1653 -16.291 -5.21716 -359 2 0.579225 9.7725 15.0704 -11.1033 15.5539 4.56692 -360 2 1.61112 8.83255 14.5724 -2.7466 -7.45742 -2.63208 -361 1 12.955 8.28126 10.1315 4.47425 -26.4789 2.77461 -362 2 13.6724 7.69661 9.75218 -12.3213 15.4477 18.6624 -363 2 12.7996 8.04439 11.0766 12.5165 -4.13221 -14.8671 -364 1 15.2413 7.99312 3.46307 21.2061 37.6089 -22.4299 -365 2 14.4756 7.7211 2.94477 -5.95544 -17.8301 8.14742 -366 2 15.6187 7.46858 4.17258 -15.9179 -18.0198 8.83427 -367 1 17.1356 6.70525 18.6386 6.47512 25.7091 -12.2215 -368 2 16.6963 5.89525 0.233999 -10.309 -8.75159 3.76643 -369 2 16.4339 7.33237 18.3357 11.2115 -13.3479 10.1501 -370 1 8.91981 7.02641 7.93476 -17.5815 -13.9195 9.00305 -371 2 9.83812 7.25537 7.853 19.0031 7.73693 -0.560136 -372 2 8.849 6.45385 8.72921 -1.20537 6.38433 -11.1549 -373 1 12.4784 0.471427 1.2 -1.5382 -11.3036 2.52426 -374 2 13.1724 0.955828 1.65737 6.96212 2.95671 -0.139484 -375 2 12.8855 0.124586 0.40059 -1.81614 4.12295 -0.743523 -376 1 5.7338 15.0104 14.483 3.21537 -3.99883 -6.81615 -377 2 4.79914 15.0689 14.6899 -13.3072 1.49299 3.3932 -378 2 6.00174 15.8892 14.196 3.10174 7.95604 -0.192962 -379 1 3.73322 6.46389 1.74186 4.97145 -11.2752 -15.478 -380 2 3.41061 7.27444 1.33141 -3.85483 5.16021 2.72417 -381 2 3.71896 6.61791 2.68352 1.01313 6.07651 8.98471 -382 1 3.85612 11.3357 12.3214 9.74989 2.64833 3.1782 -383 2 4.70398 11.747 12.5616 1.03181 -4.89631 -4.08494 -384 2 3.21292 11.8498 12.8111 -10.0411 9.11388 1.93155 -385 1 5.31882 3.86098 15.7247 -14.6622 43.9235 8.42988 -386 2 6.03513 3.29574 15.4808 24.4173 -17.8012 -3.50674 -387 2 5.69837 4.77513 15.8552 -8.87612 -28.0013 -6.19005 -388 1 14.0506 10.0984 4.70507 12.9021 5.9963 -48.2497 -389 2 14.373 9.82203 5.54065 6.42583 -15.3441 32.1568 -390 2 14.6577 9.66966 4.04903 -16.6446 6.96016 16.1133 -391 1 7.63016 17.2999 9.07082 4.88589 -1.83029 4.08955 -392 2 7.05774 17.6443 9.76408 -9.77236 -5.61109 0.722829 -393 2 7.90646 18.0745 8.58282 6.82018 7.73796 -12.3688 -394 1 4.54853 14.4989 3.92298 4.51049 -12.0827 -19.4455 -395 2 4.48676 15.3439 4.34231 1.7531 23.2793 6.06498 -396 2 4.47875 13.8474 4.61218 -0.893081 -14.6097 11.9436 -397 1 14.1162 7.44072 15.859 5.72353 -2.97717 1.52707 -398 2 14.8925 7.45204 15.2793 -3.03398 0.324075 5.79835 -399 2 14.4079 7.84098 16.6936 -1.38652 -1.7593 -3.67135 -400 1 2.91046 18.3824 1.92161 -14.6763 12.8451 -3.99897 -401 2 2.56811 17.7851 1.23066 -1.64793 1.84374 10.7046 -402 2 2.14175 0.293363 2.23042 22.3557 -16.8939 -8.97037 -403 1 8.00583 1.57089 4.46736 31.4122 8.97246 -10.4438 -404 2 7.40416 1.98491 3.8452 -8.42929 2.78546 -1.25861 -405 2 8.8818 1.75969 4.05638 -17.375 -7.71187 12.4181 -406 1 2.50572 14.1939 17.7606 -21.3738 -1.77578 0.320632 -407 2 1.88811 13.4733 18.0291 6.14349 16.4853 -5.08899 -408 2 3.36784 13.821 17.8832 22.941 -11.7322 7.4453 -409 1 0.984409 1.95477 13.9081 14.9076 0.866869 -10.4657 -410 2 1.09683 1.70126 14.8211 1.02253 -2.39927 14.2505 -411 2 18.6933 2.04344 13.7674 -16.8072 2.56857 -0.576968 -412 1 4.29327 0.177122 13.8951 16.4248 3.49785 -13.6548 -413 2 5.17049 18.4046 13.9646 -5.43827 4.9033 -2.01246 -414 2 3.78721 18.4389 14.598 -10.2443 -5.04864 16.3534 -415 1 7.35353 0.990853 18.4538 -34.7507 -7.39683 16.7648 -416 2 7.55815 0.737816 17.5561 -3.16307 -6.20953 -15.156 -417 2 6.35665 0.974064 18.6083 33.4978 7.02218 -7.3799 -418 1 15.8311 18.4256 13.8966 -40.0758 9.01377 -20.0242 -419 2 14.87 18.5763 13.7207 27.6408 -4.60797 -2.68704 -420 2 15.8417 18.2976 14.8321 10.6174 3.57585 21.6768 -421 1 10.2864 4.58419 16.2444 -24.4222 -37.2091 -9.88285 -422 2 11.2299 4.68793 16.3674 13.142 -4.29349 -1.09379 -423 2 10.1171 3.59079 16.124 8.18179 40.05 5.52806 -424 1 15.8917 17.7071 4.46459 -20.0388 -20.4222 2.09772 -425 2 16.4651 18.4471 4.57513 18.3163 24.2221 3.8588 -426 2 15.0409 18.0029 4.83395 4.42355 -1.752 -6.47073 -427 1 6.88773 17.6166 13.9821 -38.4037 0.167583 13.1844 -428 2 7.46394 17.6315 14.7417 15.8748 3.42447 12.5511 -429 2 7.41699 17.4009 13.2391 27.9809 -3.71977 -23.5355 -430 1 13.1764 6.43911 6.52144 -5.83912 -0.258919 -12.4557 -431 2 14.0695 6.77261 6.34605 -1.47407 -3.35023 -0.470203 -432 2 12.7466 6.3372 5.63472 11.513 2.45032 19.1456 -433 1 7.86196 2.29978 9.4638 -2.97627 -2.7765 -21.1046 -434 2 7.31086 2.09746 10.2267 -8.88065 1.6173 3.7395 -435 2 7.37564 1.98398 8.66115 7.69705 6.95472 18.2428 -436 1 15.1916 14.7366 13.8236 -12.2847 5.72199 -1.13466 -437 2 14.8954 15.0381 14.6996 2.36081 -1.57038 -3.3629 -438 2 14.579 15.1371 13.1848 7.3504 -2.29354 4.97967 -439 1 9.39483 8.42303 3.86324 -21.5436 -11.8424 -10.9865 -440 2 10.2164 8.84977 4.07537 16.3384 7.87643 5.27894 -441 2 9.57157 7.47345 3.83359 1.44741 0.673327 1.03302 -442 1 17.655 13.5671 16.4489 -7.58846 13.4511 -15.7424 -443 2 16.7203 13.3469 16.3992 -7.59268 -4.18946 5.70215 -444 2 17.688 14.4057 15.9472 10.2114 -8.11811 3.61388 -445 1 4.94979 10.486 2.86622 25.3355 -10.7625 -10.0508 -446 2 5.84023 10.0991 3.03563 -22.0316 6.96347 2.01482 -447 2 4.71704 10.9487 3.67532 0.603793 8.46932 2.75775 -448 1 3.68042 8.39717 9.8747 -7.87972 -17.3414 17.5888 -449 2 3.759 9.34077 9.71499 3.24219 9.53521 -0.886609 -450 2 3.55014 8.28216 10.8428 3.92085 5.02512 -16.6805 -451 1 15.9973 6.92061 5.87772 4.82031 -5.03924 3.59177 -452 2 16.6812 7.41263 6.34454 2.21588 0.961055 0.440265 -453 2 16.3186 6.0008 5.83915 -7.41322 12.2727 -5.03736 -454 1 15.3004 7.2666 8.94213 -32.1238 -12.1179 -31.7334 -455 2 15.9839 7.55437 9.51768 24.5834 17.5628 17.3411 -456 2 15.1488 7.91682 8.21973 7.72693 -8.10504 16.1569 -457 1 6.21705 12.8062 12.747 -22.7002 13.2796 -10.093 -458 2 7.05571 12.494 13.0465 21.6431 -16.5072 9.89045 -459 2 6.01919 13.5682 13.3077 2.09027 1.41895 1.21426 -460 1 12.1299 4.57596 13.1432 22.4432 17.9492 20.1123 -461 2 12.1793 4.58175 14.1216 4.56317 3.76233 -12.2652 -462 2 11.3861 4.04706 12.9369 -26.6961 -18.2025 -7.73732 -463 1 11.4375 8.07047 7.90979 27.6542 -15.5792 16.7856 -464 2 12.1952 7.52933 7.56059 -23.0528 10.899 -6.13628 -465 2 11.6627 8.11033 8.86659 -7.72222 6.32108 -19.0792 -466 1 16.9453 10.7968 7.63148 -3.5821 -10.5143 21.6719 -467 2 17.6495 10.1525 7.46889 2.86773 -0.504685 -4.5375 -468 2 16.8108 11.3218 6.85057 1.29813 10.4979 -20.4226 -469 1 5.19425 18.0282 10.6847 0.056878 3.62778 8.77145 -470 2 4.66571 17.4143 11.2104 4.95394 3.09506 -2.12913 -471 2 4.57063 18.3664 10.0251 3.33377 -5.62986 -0.929046 -472 1 7.60987 17.4226 1.56636 -8.76834 11.2024 10.6057 -473 2 8.12097 16.6429 1.35059 3.07922 -5.96866 -14.3061 -474 2 7.62904 18.066 0.842261 4.5937 -2.56699 -0.219584 -475 1 1.93734 12.9421 13.6328 4.51097 2.01356 -10.2989 -476 2 1.33249 12.4003 14.1383 -4.04092 -5.16916 8.28012 -477 2 2.1441 13.7105 14.1828 3.43289 -0.0153047 1.69165 -478 1 9.36109 6.77295 14.8254 28.0404 -16.4025 -23.0383 -479 2 9.79586 5.92856 15.0909 -10.7826 13.1246 6.51236 -480 2 9.73683 6.91972 13.9197 -17.1545 2.79671 17.5547 -481 1 15.2759 4.38629 10.7467 0.911226 -10.0818 1.35121 -482 2 16.2063 4.08729 10.7712 -9.28003 7.88291 1.38983 -483 2 15.15 4.95989 11.5268 6.34994 -5.62458 -10.0329 -484 1 11.4488 6.21672 0.0274361 8.35139 15.4334 1.07365 -485 2 11.547 5.26836 -0.0918922 -6.12153 -5.65013 -4.62095 -486 2 10.5221 6.46299 18.5238 -1.7877 -10.3718 -2.04901 -487 1 18.4903 11.4194 14.9121 8.77287 -18.4144 -27.074 -488 2 18.1021 11.8559 14.1353 -5.2902 0.217957 4.39134 -489 2 18.3331 12.0271 15.6113 -5.23497 22.6985 22.6894 -490 1 7.12593 9.28496 7.31024 -23.9992 -6.07508 6.39318 -491 2 6.74279 8.45494 7.66169 4.89732 10.9664 -5.80838 -492 2 8.06011 9.1434 7.29118 23.2007 -3.69072 -2.70719 -493 1 18.3302 15.3588 12.1663 1.84912 0.0598217 5.47138 -494 2 0.628985 15.4631 11.9685 -1.01298 4.74778 -2.81479 -495 2 17.8359 15.8974 11.5264 -1.18931 -3.22386 -0.556154 -496 1 16.5345 4.36456 5.22425 -62.6276 -15.6665 42.2949 -497 2 16.4135 4.0372 6.15475 14.4043 4.47956 -24.0603 -498 2 17.4334 4.499 5.03806 48.2264 1.34274 -11.6623 -499 1 17.733 3.12037 10.7685 2.78093 13.2032 15.2159 -500 2 18.62 3.27348 11.1411 -3.87004 4.46435 -8.2182 -501 2 17.7411 2.21797 10.4818 -1.03268 -21.1847 -12.2715 -502 1 12.2988 18.6545 10.1426 21.4258 -12.4002 -10.8053 -503 2 11.5002 0.459945 10.3706 -28.4452 4.23152 6.39845 -504 2 12.9389 0.72089 10.1511 12.8533 4.08749 0.539844 -505 1 10.4313 9.72872 12.541 3.98701 -3.38274 8.58973 -506 2 11.1703 9.84044 13.1623 -1.01011 3.74187 -3.45859 -507 2 10.4039 8.77038 12.4204 -3.66163 0.188688 -4.07709 -508 1 0.615048 2.63664 7.2276 -9.26807 24.3162 -18.5585 -509 2 0.353188 3.56967 7.37092 2.19049 -16.4853 1.00686 -510 2 0.949026 2.32684 8.06684 4.15829 -4.72879 9.31366 -511 1 0.333537 15.2707 6.93805 -1.63763 -14.4268 -44.2284 -512 2 0.559673 15.3175 7.85021 9.94673 -3.51892 30.6084 -513 2 0.629693 14.3791 6.62643 -7.55161 17.6489 9.10591 -514 1 17.0527 6.91364 14.9743 11.0217 0.359412 -1.38417 -515 2 17.7989 7.54943 14.9113 -7.11537 -10.2599 3.19545 -516 2 17.3979 6.08953 15.3732 -1.90278 10.2985 -1.25317 -517 1 9.14167 12.5321 7.98456 -51.8007 8.58975 -7.36144 -518 2 9.48882 11.7504 7.57305 13.8522 -18.8219 -15.7166 -519 2 8.22261 12.6161 7.58551 34.0094 -0.937982 16.6367 -520 1 1.15656 1.63828 2.76743 -9.76481 2.77041 -4.10292 -521 2 0.864287 2.18836 2.03128 -7.19413 -5.97378 -5.55322 -522 2 1.70002 2.22125 3.28253 11.7483 7.29404 14.7886 -523 1 4.17339 15.1305 9.84913 -14.3711 5.0779 2.99988 -524 2 3.91961 15.3463 8.93389 10.9385 -4.50851 5.90843 -525 2 5.03476 14.6902 9.78793 -0.575875 2.49321 0.528438 -526 1 7.3951 2.27992 14.8377 -1.12966 16.8522 -8.99686 -527 2 7.16414 1.54106 14.2639 1.26623 0.276941 -0.531744 -528 2 7.65338 3.03331 14.2573 -5.05472 -19.0282 8.30824 -529 1 18.3172 14.5403 2.1483 15.3986 5.40572 3.08201 -530 2 0.535799 14.8642 2.50804 -16.0996 -1.12956 -11.071 -531 2 17.7238 15.3001 1.99479 6.48993 -0.927096 4.3539 -532 1 10.0475 2.68059 12.9077 -3.02015 -13.9614 -15.6621 -533 2 9.89167 2.00033 12.2018 7.6523 15.7956 13.7679 -534 2 9.26985 3.25658 12.875 1.66072 1.15674 0.355625 -535 1 2.93978 8.85687 13.107 17.7725 7.3386 -7.69378 -536 2 3.37522 9.71823 12.8547 -12.3312 -24.1388 6.15133 -537 2 3.67473 8.22279 13.2377 -8.38529 8.44125 1.12687 -538 1 3.27106 8.61507 3.79074 -8.49716 -38.7584 59.7131 -539 2 3.66196 9.22584 3.22278 26.3747 36.1018 -32.8858 -540 2 3.70281 8.77413 4.67945 -18.9434 -3.96308 -29.2422 -541 1 5.92777 7.2521 8.64891 -10.8881 -6.62505 3.42768 -542 2 5.84919 6.30478 8.465 1.79189 -1.90292 -1.42585 -543 2 5.07694 7.48175 9.0605 5.83384 2.94932 1.14829 -544 1 14.8827 1.64134 1.82872 -12.6885 -28.1567 -9.76357 -545 2 15.1087 2.39997 2.36476 0.314968 13.4446 -1.58597 -546 2 15.1034 1.73075 0.884031 8.80659 10.9019 15.543 -547 1 8.66156 14.9913 0.655877 15.6167 -4.79217 23.7466 -548 2 9.42437 14.9505 1.28455 -14.0351 0.988592 -13.753 -549 2 7.99981 14.403 1.0655 -3.22335 6.28365 -6.24421 -550 1 15.4067 1.46647 7.20695 -8.82589 -12.8718 -0.882757 -551 2 14.775 0.932663 6.69065 9.74374 4.52972 3.50353 -552 2 14.8641 2.16562 7.57814 -1.0399 11.0322 0.525673 -553 1 4.92475 12.8978 18.4559 2.19674 -3.23744 10.1082 -554 2 5.23586 12.8997 0.738081 -1.33722 2.66651 -10.6279 -555 2 5.70033 13.1343 17.9365 -0.0827318 6.23371 -0.0935372 -556 1 15.3819 8.68528 18.0932 8.72121 10.5448 -14.8557 -557 2 15.8142 9.23534 17.405 -7.78496 -12.8196 8.73029 -558 2 15.2566 9.31777 0.164984 -6.85428 -0.586954 10.5179 -559 1 12.0126 3.13082 18.276 9.47145 -1.72319 12.159 -560 2 12.2482 3.16999 0.564179 -5.55591 0.644277 0.165862 -561 2 12.5655 2.41012 17.9461 -5.90061 -0.236568 -11.7395 -562 1 13.2006 12.6959 5.14014 6.0546 -4.02499 4.06103 -563 2 13.6294 11.8271 5.0147 -6.69767 7.2237 -2.15456 -564 2 13.3727 12.9234 6.07289 -1.67526 -4.52376 -7.3865 -565 1 6.1651 7.14436 0.195504 -22.0894 -12.2339 1.18179 -566 2 6.12052 8.09409 18.9477 10.183 13.9972 -1.43251 -567 2 5.2591 6.87987 0.448218 12.567 -4.05161 -1.41715 -568 1 17.6881 15.878 14.8655 -1.85909 5.77814 22.6605 -569 2 16.7739 16.1608 15.0761 11.3822 -6.39517 -19.8211 -570 2 17.8371 15.675 13.9293 -11.1648 4.64831 -4.02463 -571 1 13.1067 0.88062 16.8301 -1.16362 5.09418 6.26073 -572 2 14.0188 0.56665 16.8428 4.80395 1.33473 -1.08149 -573 2 12.5822 18.7235 16.7479 -0.784604 -6.20947 -5.79489 -574 1 10.8701 14.5014 7.48366 30.6398 4.5327 -13.288 -575 2 10.1924 13.8927 7.76637 -8.27046 -6.89901 6.40521 -576 2 11.688 13.9665 7.40985 -13.0568 5.23738 5.47236 -577 1 17.7216 8.3975 2.13341 -5.03714 18.392 15.6468 -578 2 16.8261 8.35978 2.51012 1.26608 -2.81583 -3.60077 -579 2 17.7343 7.78208 1.41002 -5.68948 -14.3091 -15.2975 -580 1 12.4651 7.83121 2.02849 6.21002 21.8293 -0.701234 -581 2 12.2371 8.77742 1.88873 1.61752 -16.1639 -0.0618129 -582 2 12.1801 7.35781 1.23988 -4.06145 -2.69746 -4.32972 -583 1 11.9912 14.5504 10.3779 26.255 2.08103 -27.6641 -584 2 12.3772 14.5828 9.46952 -12.6474 -4.22617 24.8662 -585 2 11.0517 14.669 10.2537 -15.8484 3.20565 2.09431 -586 1 6.76727 6.87556 15.5462 0.393734 11.8444 22.477 -587 2 7.69535 7.12306 15.3658 -7.56189 -7.86407 -0.973014 -588 2 6.54154 7.32616 16.388 3.13619 -10.9433 -13.6985 -589 1 7.93405 4.43454 13.181 3.70457 37.9343 33.3332 -590 2 7.23909 4.66367 12.5613 -7.79541 1.00974 -8.53955 -591 2 7.95717 5.24214 13.788 5.6586 -32.0049 -23.1645 -592 1 13.3208 12.2124 14.3278 -1.85908 1.78375 8.34338 -593 2 13.1627 11.2597 14.246 -0.36998 0.633125 0.823702 -594 2 13.6236 12.4909 13.4584 3.579 0.31603 -3.71376 -595 1 14.5678 9.48203 7.30395 8.22624 -5.55489 -6.16459 -596 2 15.3274 10.0218 7.53849 6.73854 1.05081 2.13221 -597 2 13.8344 9.86252 7.77014 -14.2105 5.15772 9.40205 -598 1 12.6689 16.8584 3.2838 3.32354 22.4122 -6.02395 -599 2 12.8251 17.4603 4.02708 -0.185303 -8.85949 -0.0347213 -600 2 12.7374 17.4469 2.50984 -1.71014 -6.46341 4.85536 -601 1 0.984375 7.0735 17.3432 34.0501 -3.91376 2.11413 -602 2 0.125246 6.96907 17.7347 -25.3968 2.18392 3.09576 -603 2 0.950307 7.67775 16.5933 -9.77339 5.8232 -4.41721 -604 1 13.0022 4.84407 15.777 5.081 -10.3329 -5.56354 -605 2 13.7485 4.25418 15.5901 -10.0146 -2.33354 7.04552 -606 2 13.4521 5.67804 15.8535 -1.12386 24.7122 1.66863 -607 1 2.36131 3.40053 5.10919 -9.6311 -14.0051 -9.38531 -608 2 1.85776 3.14724 5.88615 -5.89279 -11.6191 4.05299 -609 2 2.64546 4.27356 5.34111 14.5219 19.3293 2.74972 -610 1 8.16093 10.9198 13.7208 -5.48668 -10.5203 36.1407 -611 2 8.01338 10.5218 14.6488 11.4544 18.6016 -43.3573 -612 2 8.9553 10.5154 13.3405 3.89898 -1.19123 3.66799 -613 1 13.0685 1.50992 13.279 -14.1832 25.7313 -25.8855 -614 2 13.6244 1.50815 12.4613 -6.9447 -4.36872 19.5281 -615 2 12.4297 2.25673 13.1075 20.3356 -25.0236 11.2619 -616 1 6.62047 13.6375 2.07221 -5.18984 1.0977 1.00923 -617 2 6.01355 14.0796 2.67998 -4.17105 4.32933 -3.39809 -618 2 7.10668 13.0566 2.65885 8.90022 -6.51269 2.26225 -619 1 15.8066 6.3469 12.5124 13.7748 11.2213 20.1038 -620 2 16.2844 6.87459 11.8544 0.57451 -1.64399 2.92177 -621 2 16.2805 6.52872 13.3684 -12.0243 -5.9969 -18.7155 -622 1 16.7622 0.649503 9.5351 11.3629 -0.534141 16.2257 -623 2 16.8233 18.3334 9.63984 -7.20854 -2.096 2.62458 -624 2 16.3504 0.825019 8.69009 -8.20455 0.909068 -17.3039 -625 1 6.16155 11.6721 8.23727 11.0478 -14.7079 4.32064 -626 2 5.37204 11.4355 8.7099 -18.5694 3.37101 8.66714 -627 2 6.52549 10.7898 8.06052 6.85938 7.24602 -7.48704 -628 1 2.80718 8.60686 0.397493 -27.1124 -12.7057 -15.0387 -629 2 2.16203 8.12721 18.4284 20.3601 19.9434 23.0266 -630 2 2.28863 9.2379 0.937046 1.66532 -5.5958 -10.4069 -631 1 10.1061 10.2794 6.574 -2.68384 6.39054 8.98367 -632 2 10.587 9.61275 7.07222 2.60765 -6.52577 4.24337 -633 2 10.6348 10.4062 5.77746 -5.53346 0.236498 -3.27199 -634 1 6.84319 15.7735 6.74802 2.92919 -7.52667 3.13791 -635 2 7.22287 16.2754 7.48672 -6.2609 -2.86584 0.474311 -636 2 7.16745 16.2182 5.95944 -1.73758 9.59963 -7.48558 -637 1 6.59004 12.8453 5.92771 5.9232 5.70246 -10.7633 -638 2 6.81648 13.7523 6.14266 -3.08056 9.02497 3.95142 -639 2 6.18071 12.4806 6.71128 -2.95494 -1.85994 5.08984 -640 1 16.7187 12.5557 9.81602 -6.97981 -8.42056 3.44329 -641 2 16.7367 11.9049 9.10465 3.04519 -4.31121 0.702836 -642 2 17.0063 13.3635 9.40922 2.88649 12.8114 -1.84814 -643 1 6.30344 2.78963 2.73877 -9.04367 -13.9111 -2.70816 -644 2 6.4136 3.72217 2.50807 2.58545 1.58307 -3.30667 -645 2 5.8765 2.3355 1.98292 3.38351 11.0448 5.4768 -646 1 10.696 2.92954 3.25253 -4.78239 0.546409 -3.48797 -647 2 10.285 3.77274 3.47459 -3.26512 -0.523652 -3.33277 -648 2 10.2907 2.61783 2.41902 1.90367 1.74508 6.25714 -ITEM: TIMESTEP -100 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.7952 6.55188 17.82 -14.0925 -19.7636 -3.75378 -2 2 7.88023 6.44026 18.1695 19.5523 6.07432 -5.80163 -3 2 8.99571 5.7855 17.2401 -2.64216 11.7935 9.74201 -4 1 0.13387 8.39658 6.71777 11.0686 -17.0219 51.8315 -5 2 0.297964 8.15416 5.82611 3.65759 -8.78146 -34.4276 -6 2 0.663997 7.73523 7.26654 -21.1289 27.238 -19.6589 -7 1 8.71966 0.469223 7.04147 6.63626 1.40123 -3.67752 -8 2 9.62406 0.435013 6.6778 -11.0722 1.83914 2.93454 -9 2 8.2146 0.970711 6.38506 4.19741 -2.20649 2.49068 -10 1 6.44826 1.6863 11.7796 22.1018 -16.0737 -10.0998 -11 2 5.81214 2.23354 12.2013 -20.9633 15.3476 12.0772 -12 2 6.02072 0.836228 11.6256 -4.8988 -3.15305 -3.34718 -13 1 6.89097 5.45035 2.38694 -14.0878 18.1315 0.804401 -14 2 6.23022 6.01625 2.92115 27.2653 -21.4077 -23.7527 -15 2 6.91491 5.77412 1.45583 -9.40281 2.39732 25.4334 -16 1 16.2334 10.2315 16.0664 1.22095 -12.8583 -8.35396 -17 2 17.1105 10.2758 15.679 0.521344 2.88453 0.293596 -18 2 15.9464 11.1361 16.1778 -3.48259 10.2735 3.78324 -19 1 10.8573 15.0007 2.35193 -8.17785 -20.274 -7.01899 -20 2 10.8024 14.5151 3.19219 -3.98998 0.859093 -1.88791 -21 2 11.3201 15.8014 2.5578 8.92048 16.4226 10.3474 -22 1 17.1726 8.21805 11.024 14.0848 -19.0512 -23.2094 -23 2 16.691 8.91369 11.4632 -8.36385 12.6057 9.94503 -24 2 17.8921 8.64427 10.518 -5.71892 -0.131476 8.97419 -25 1 14.5956 15.9799 16.3132 20.7515 -13.8502 3.42179 -26 2 13.7469 16.3872 16.1713 -21.6627 3.23661 7.28294 -27 2 14.5521 15.3865 17.0935 -1.40849 8.21009 -3.21798 -28 1 12.1509 13.2395 0.573493 6.57205 3.5904 2.72349 -29 2 11.837 13.3986 18.3303 -3.80405 -1.74926 -15.723 -30 2 11.7012 13.9105 1.09717 -2.12612 0.929616 9.94365 -31 1 9.32377 5.48511 3.80515 37.2224 0.919853 24.8976 -32 2 8.88878 5.295 4.65312 -11.8166 2.00864 -7.28102 -33 2 8.70235 5.44743 3.10202 -35.0307 -2.6733 -15.0358 -34 1 1.53449 3.88906 11.5762 -21.4592 42.8438 -26.3691 -35 2 1.39761 4.77552 11.9865 7.05639 -9.88004 -9.22537 -36 2 1.89707 3.34621 12.2331 21.1403 -27.4328 37.6181 -37 1 2.11621 6.94729 8.0812 -5.52003 -16.2776 -1.04121 -38 2 2.5746 7.45442 8.7366 8.45236 15.6822 11.2536 -39 2 2.08388 6.07661 8.50513 -4.57751 -6.44388 -7.47435 -40 1 5.24695 4.43578 7.8028 -6.30612 26.2857 -2.69952 -41 2 5.36677 3.49844 7.65426 0.215716 -12.5366 -1.65761 -42 2 4.56392 4.76953 7.18377 10.1949 -9.65667 2.91339 -43 1 3.43524 2.88686 17.4376 -21.7675 5.87472 14.6558 -44 2 3.90981 3.17382 16.6701 17.8952 10.4272 -14.0542 -45 2 2.87759 3.6541 17.6984 8.18662 -9.04753 2.1829 -46 1 7.55778 5.57378 6.15352 3.99821 9.40639 19.9011 -47 2 8.12518 6.20749 6.66299 -12.9927 -14.0765 -9.88952 -48 2 6.98227 5.15891 6.82729 7.75312 -1.10557 -10.9113 -49 1 9.77611 7.00478 12.0482 -6.90333 -2.64414 -8.04886 -50 2 10.0224 6.11753 11.7611 0.642082 2.81741 -0.891425 -51 2 9.0843 7.2891 11.4183 2.80801 -0.947675 5.79882 -52 1 14.1423 3.90191 8.16294 -23.6925 4.35767 -24.2753 -53 2 13.5235 4.53411 7.72337 18.2577 -11.8103 7.89417 -54 2 14.4024 4.31063 8.97869 6.95814 7.70003 16.5888 -55 1 4.54437 17.2359 3.8519 4.03565 10.1791 3.31349 -56 2 5.34213 17.7268 4.08304 4.36901 -6.62302 -0.267376 -57 2 4.17051 17.7127 3.09453 -6.96766 -2.87365 4.53203 -58 1 16.1339 16.4921 10.5971 24.4543 -12.0388 -34.7313 -59 2 15.4578 16.6815 11.2098 -23.1752 5.77424 26.3474 -60 2 15.6745 15.9439 9.92709 9.81353 9.26167 7.23238 -61 1 1.98282 4.87023 -0.0102057 11.328 -31.2723 15.691 -62 2 2.56866 5.25094 0.666382 -3.10152 5.14206 -1.69339 -63 2 1.65849 5.5885 18.1127 -8.58794 22.0564 -11.6074 -64 1 11.0975 13.3336 16.4568 21.334 -26.4555 -13.6253 -65 2 10.7319 12.43 16.5661 -7.83355 14.7592 4.38577 -66 2 11.7328 13.1734 15.7328 -3.59268 8.82171 6.12988 -67 1 9.983 10.9188 16.8195 21.8027 -17.9597 14.5818 -68 2 10.5015 10.1139 17.0687 -12.258 16.9146 -11.8156 -69 2 9.08607 10.6082 16.6912 -8.94921 1.38614 -3.26281 -70 1 11.9148 17.5563 13.4787 -11.9158 -12.5975 -1.23623 -71 2 12.5676 17.2101 12.8515 -0.0246338 2.67811 4.16536 -72 2 12.0003 18.5089 13.4756 8.75914 10.3848 -3.31648 -73 1 6.43245 9.54572 12.2957 1.63429 -3.34072 -14.2423 -74 2 7.08046 9.15867 11.6656 -10.0512 7.63496 6.98562 -75 2 6.90317 10.1892 12.8448 2.76093 -9.73394 -7.4892 -76 1 16.2985 12.7819 2.78073 -6.76278 9.02259 -0.251856 -77 2 17.1507 13.1937 2.56739 -3.11425 -2.92719 1.79117 -78 2 15.6658 13.5347 2.78258 7.1706 -12.5209 -0.796151 -79 1 0.705375 12.7757 5.80641 -31.4327 0.785322 -26.0818 -80 2 0.964058 12.7408 4.86595 9.86444 -3.28161 8.94612 -81 2 18.3663 12.6813 5.72517 19.7421 -2.33124 11.5636 -82 1 5.30386 16.3127 18.466 5.80758 -1.43031 -6.37222 -83 2 5.80257 15.6526 17.9366 -5.42534 13.184 13.7491 -84 2 5.92544 16.7092 0.45256 -3.43112 -6.46136 -2.11967 -85 1 0.781035 7.63768 4.09742 11.023 -5.93732 13.9838 -86 2 0.258202 7.96457 3.37539 -14.755 3.95315 -10.1558 -87 2 1.66078 7.97253 3.8829 3.26007 -0.00880383 4.41534 -88 1 3.24417 9.16605 6.56429 -20.4701 -14.3326 2.83801 -89 2 3.57159 8.65908 7.31953 1.49107 7.58135 -6.52778 -90 2 2.30098 8.88971 6.4655 20.5558 12.7829 2.43715 -91 1 7.26627 10.4004 16.2591 -15.7562 -6.32656 27.9079 -92 2 6.82075 11.2368 16.4586 5.73239 -2.42146 -6.93429 -93 2 6.93167 9.82605 16.9811 6.22417 8.86745 -10.8084 -94 1 10.9892 0.849679 5.07849 4.12027 -5.76689 -13.93 -95 2 11.0513 1.64213 4.53259 0.725375 9.02843 9.39609 -96 2 10.6504 0.238952 4.4041 -0.868918 -3.08012 11.6628 -97 1 4.18223 2.98976 13.1617 1.80285 -9.79496 -4.9743 -98 2 4.46754 3.28562 14.0477 -4.0491 -7.36491 -7.89898 -99 2 4.03841 2.01285 13.1683 3.67857 16.3758 11.7633 -100 1 8.4888 10.2856 1.85141 10.3375 -10.6918 -8.28538 -101 2 8.43451 10.9691 2.52904 -3.58901 -0.686288 7.94652 -102 2 8.82874 9.48425 2.29142 -6.1923 10.8646 1.43904 -103 1 10.2336 1.64305 15.4458 -13.2429 9.10796 4.38269 -104 2 11.1732 1.63861 15.572 16.9305 -2.55664 -1.17381 -105 2 10.0536 2.05804 14.5895 6.55462 -3.46994 -1.37038 -106 1 2.58993 12.7242 7.97336 -7.23425 -8.94691 3.8681 -107 2 3.01571 13.5704 7.82234 5.57764 5.06786 -6.45979 -108 2 1.98486 12.5774 7.23174 0.806159 4.05811 0.362671 -109 1 3.90685 11.8307 5.02738 -19.955 -7.05304 -0.3571 -110 2 3.70751 11.1281 5.68153 3.09094 12.242 -8.4391 -111 2 3.06715 12.0092 4.53628 19.8771 -7.15241 7.2697 -112 1 6.7679 14.5791 16.9276 2.77817 -6.983 11.0716 -113 2 7.71708 14.7379 16.9268 0.980214 1.28706 0.809355 -114 2 6.44853 14.8723 16.076 -0.709014 -5.22289 -12.1565 -115 1 14.1752 14.508 3.1348 7.33594 -12.7834 -7.22412 -116 2 13.6105 15.2801 3.10139 -3.55206 9.35654 4.80996 -117 2 13.7682 13.8754 3.73922 -4.33905 3.15851 6.00261 -118 1 8.77346 18.0937 16.1268 -49.3086 -19.2657 7.09896 -119 2 9.29148 17.2891 16.2682 10.0054 9.31596 -1.94744 -120 2 9.22615 0.228463 15.833 27.8858 8.66202 -5.29688 -121 1 4.63977 1.75161 4.89947 12.6555 12.3233 -26.7382 -122 2 3.82082 2.25711 4.97207 0.159842 -3.07614 2.23584 -123 2 5.05477 2.09313 4.05862 -7.26402 -10.6651 28.8422 -124 1 15.0293 12.6717 16.5117 -23.31 -0.861404 35.6256 -125 2 14.4426 12.7177 17.3057 24.815 2.28331 -11.4604 -126 2 14.393 12.496 15.8301 -9.60755 -0.359254 -28.8722 -127 1 15.7282 18.4115 16.8424 17.2085 30.6847 -2.58542 -128 2 16.585 18.5255 17.3163 -17.0651 -10.3906 -2.34083 -129 2 15.5073 17.4884 16.7844 1.64687 -19.4864 2.05956 -130 1 1.3653 1.32145 16.674 4.57571 12.7751 22.4809 -131 2 2.22966 1.72757 16.8986 -13.3853 -7.67206 -8.47788 -132 2 0.843747 1.53379 17.4789 2.23908 -6.3926 -16.4011 -133 1 18.2502 4.28823 15.9426 5.59379 -7.24598 -18.3859 -134 2 17.8025 3.49471 15.6029 3.53909 11.4984 4.55434 -135 2 0.380345 4.42598 15.3659 -10.3938 -1.91133 11.4 -136 1 12.0179 17.0993 16.1449 -24.7595 -29.8482 27.6473 -137 2 11.2904 16.5264 16.5371 30.7476 29.6052 -3.96723 -138 2 11.7854 17.0696 15.2267 4.30162 8.23296 -25.5613 -139 1 16.0455 2.77586 18.2041 10.6955 -6.31261 -1.53201 -140 2 15.9135 3.65525 18.5895 -10.0784 -5.09061 -10.2232 -141 2 15.7148 2.7749 17.2908 -2.70848 4.2718 2.75475 -142 1 6.57887 13.7167 10.0128 0.388305 24.4332 24.1101 -143 2 6.2636 13.3347 10.8463 6.37938 -3.40375 -0.55213 -144 2 6.43171 13.0818 9.3305 3.17506 -19.669 -12.997 -145 1 10.1062 18.565 2.71626 12.0596 2.32822 -17.6158 -146 2 10.7563 0.294125 2.0815 -9.9929 -7.47975 8.60443 -147 2 9.2984 18.4331 2.20633 -1.12272 -0.999648 5.59115 -148 1 3.10044 17.6571 6.21769 -0.590198 -1.20238 18.0356 -149 2 2.16339 17.7471 5.9649 14.558 -0.242179 -11.811 -150 2 3.6505 17.6877 5.42436 -8.00238 0.252249 -9.63341 -151 1 12.5899 16.7797 7.85568 11.434 -9.28582 -14.859 -152 2 11.8995 16.1049 7.73478 -4.76829 8.38316 1.604 -153 2 12.3367 17.3735 8.55676 -7.89443 8.69289 16.0625 -154 1 14.8958 15.3252 8.42405 -10.9907 16.0866 -10.412 -155 2 14.2257 15.9607 8.05927 9.60746 -16.915 15.6813 -156 2 15.568 15.2992 7.73812 1.83068 -0.846784 -8.90808 -157 1 17.9236 18.2959 0.16927 -20.6229 -20.5305 -14.2597 -158 2 18.7101 17.7336 18.8116 8.98564 4.8691 -3.01699 -159 2 18.0908 0.428516 0.675884 12.0916 17.8267 11.1415 -160 1 0.800533 10.4853 1.48213 -15.9305 -52.1134 32.1201 -161 2 0.0210499 9.87138 1.72712 35.348 27.3948 -12.4938 -162 2 0.488783 11.092 0.839839 -12.4886 25.7711 -24.5144 -163 1 1.85398 12.3107 3.26054 -2.39029 3.71051 2.5874 -164 2 1.61156 11.5651 2.68837 -2.80207 3.45241 0.205878 -165 2 2.01622 13.0664 2.66785 -2.08994 -5.59574 4.32216 -166 1 0.726068 17.2941 4.97534 23.1964 8.93599 -27.6283 -167 2 -0.00504426 17.9045 4.96895 -11.3657 3.83105 9.40925 -168 2 0.6848 16.6356 5.64734 -16.8394 -17.6158 22.5419 -169 1 0.979774 0.931094 9.39103 18.34 6.67236 9.68687 -170 2 1.13606 0.587208 10.3041 -6.25966 0.627701 -15.4141 -171 2 0.222638 0.493139 9.00427 -6.20505 -6.29115 6.11619 -172 1 16.8132 2.44689 13.4524 12.1018 18.2567 -5.29927 -173 2 16.9941 2.74318 12.5312 -5.60486 -9.11594 12.8952 -174 2 16.5475 1.52939 13.4414 -4.39811 -15.2301 -8.28386 -175 1 2.68823 16.0572 12.0971 4.35106 -7.5731 1.60029 -176 2 3.00862 15.6347 12.9147 -3.00711 3.68751 -12.4652 -177 2 3.25289 15.7623 11.3532 -3.53001 -2.50035 7.7005 -178 1 16.365 15.3972 6.07793 1.10786 -2.726 6.22736 -179 2 17.2616 15.5854 6.39959 0.338369 -3.43469 -2.74975 -180 2 16.1217 16.1306 5.49548 2.77772 2.55878 -2.13745 -181 1 5.71885 5.23685 11.7571 -1.38587 -22.0348 -7.59079 -182 2 5.34065 5.94353 12.2818 1.95161 11.9795 4.35233 -183 2 5.13977 4.47517 11.9216 1.17844 4.76848 -1.31072 -184 1 15.1029 4.9502 0.771222 1.99697 3.13949 16.3358 -185 2 15.0181 4.74755 1.72068 1.03511 -0.706475 -1.64751 -186 2 14.2572 5.32925 0.539529 -7.17443 2.24029 -6.36177 -187 1 16.4241 16.5209 1.77175 11.7834 22.2537 -31.9797 -188 2 16.1353 16.901 2.59837 -3.82757 4.70614 16.3909 -189 2 16.7243 17.3043 1.2165 -7.10171 -29.7856 17.5505 -190 1 0.166785 4.90105 4.02875 -9.807 6.14851 -6.2016 -191 2 0.490919 5.80972 4.19933 1.47178 -10.2493 -2.87817 -192 2 0.85797 4.25703 4.16889 13.481 4.94217 6.1798 -193 1 2.95388 15.1092 15.162 10.7369 -8.35154 -8.83455 -194 2 2.79081 14.8128 16.074 0.0767364 3.70074 1.09557 -195 2 2.55949 15.9866 15.0864 -8.26758 5.41964 7.36053 -196 1 1.08589 14.7081 9.5149 24.8711 -1.95174 9.92838 -197 2 2.02655 14.926 9.73253 -22.6422 -7.57261 -8.5802 -198 2 0.981604 13.769 9.74603 1.17561 7.47496 0.770389 -199 1 13.5787 16.5188 11.5692 -12.2314 13.2219 -8.78769 -200 2 13.3397 17.246 10.9551 -0.181138 -8.24863 9.65793 -201 2 12.9892 15.7954 11.3146 2.83531 -7.80051 -5.41791 -202 1 4.81777 1.55092 0.678258 -26.6156 -3.92273 4.29753 -203 2 4.35705 2.21925 0.160828 3.99581 1.83661 -5.90848 -204 2 4.05187 1.04139 1.04246 22.8613 -3.7169 0.169547 -205 1 1.54475 18.6679 11.892 -7.41525 16.2224 7.56704 -206 2 1.47416 0.586534 12.6867 1.33096 -5.97454 -6.01551 -207 2 1.79005 17.7987 12.209 7.72027 -7.46968 0.191542 -208 1 11.4358 10.1471 4.23265 -10.894 -3.87129 -8.35951 -209 2 11.2613 10.4034 3.31126 9.28636 4.56211 3.82985 -210 2 12.3915 10.0236 4.32197 -4.85978 3.43988 -0.432274 -211 1 8.20336 12.1359 3.88849 -13.0458 16.1374 35.7669 -212 2 8.99874 12.5954 4.16275 16.0075 -1.33649 -14.8839 -213 2 7.69556 12.2697 4.73273 -2.96338 -15.3566 -29.2591 -214 1 14.5957 4.06338 3.37559 11.9385 -4.24509 -11.5663 -215 2 15.1907 4.01381 4.14053 1.35901 4.80596 -1.61984 -216 2 13.7786 4.41816 3.71066 -15.4173 6.10577 6.17301 -217 1 5.71905 1.6749 7.61995 8.80947 6.26404 67.7498 -218 2 5.099 1.08549 8.07836 1.13728 7.44943 0.131268 -219 2 5.55556 1.51371 6.73852 -13.1925 -8.9768 -74.4163 -220 1 17.8986 1.04478 4.82737 2.1754 -1.83476 -0.744307 -221 2 18.4917 1.14925 4.06283 -1.19754 2.46044 8.41233 -222 2 18.3052 1.49477 5.5864 -1.29774 -0.0865267 -3.68542 -223 1 6.84138 9.15652 4.5536 4.1666 1.31036 -3.45285 -224 2 6.90548 9.53593 5.43168 -5.85674 1.32054 6.56912 -225 2 7.76285 8.95875 4.34348 -1.51129 -0.833856 -3.18299 -226 1 2.51554 14.7147 2.08788 -0.0450507 -1.43316 -6.26715 -227 2 3.18184 14.7861 2.78103 3.7873 -1.55841 0.251503 -228 2 3.00277 14.5163 1.27395 -5.30581 6.45149 3.77223 -229 1 17.2192 13.0031 13.0554 -12.0926 -3.19634 4.57291 -230 2 16.3553 13.3969 13.3572 27.3304 0.34804 -8.60607 -231 2 17.7786 13.6982 12.6582 -16.3476 4.90844 7.68697 -232 1 14.8182 10.5634 1.61386 4.26778 13.3748 6.0388 -233 2 15.4677 11.1895 1.9919 -6.32062 -5.48184 -5.48699 -234 2 13.979 11.0422 1.62876 3.88819 -6.35193 -1.63244 -235 1 5.61579 6.74404 4.50101 -16.4591 -25.6922 -2.42498 -236 2 5.98931 7.61359 4.54862 8.72135 21.7956 -0.434523 -237 2 6.18395 6.1944 5.05334 5.89398 3.69136 0.98365 -238 1 7.99723 8.25195 10.2692 14.8304 8.84149 10.0706 -239 2 8.65992 8.88256 9.91656 -9.90097 -8.80766 -1.78449 -240 2 7.59566 7.7759 9.52484 -1.48617 9.19501 4.49734 -241 1 13.4628 18.4324 5.71378 17.6235 1.75148 -9.47684 -242 2 12.708 0.350866 5.56458 -19.7852 7.87128 -2.36248 -243 2 13.2811 17.9777 6.53219 -7.30606 -12.1428 7.93723 -244 1 0.0668655 2.55772 0.44163 -1.64079 -15.5797 1.12414 -245 2 17.7792 2.62308 0.158326 7.01821 10.3157 -4.2768 -246 2 0.560589 3.37114 0.261458 -5.35649 7.7487 -2.70304 -247 1 12.8473 10.8167 9.6749 -29.1069 48.3462 -20.1155 -248 2 11.856 10.995 9.62541 32.1605 -20.6147 5.13184 -249 2 13.0142 9.92242 9.94244 -8.5776 -22.9331 5.75343 -250 1 0.607197 12.3488 11.1216 10.7177 -2.21067 3.69277 -251 2 18.3016 12.4338 11.1296 -15.0263 -0.672926 -5.71109 -252 2 0.887353 12.7089 11.9725 7.71276 -2.01358 -2.19338 -253 1 5.32001 7.36668 13.2938 5.32433 15.1635 7.63099 -254 2 5.70557 8.20602 12.9842 -2.91102 -7.98825 -6.07053 -255 2 5.82609 7.21997 14.1065 -9.96591 -5.08448 1.55341 -256 1 1.1733 6.74916 11.943 -30.749 -23.7015 -12.6924 -257 2 0.265139 7.01822 11.7017 14.0517 -0.957096 2.97943 -258 2 1.61086 7.53614 12.2133 15.6557 23.6476 13.031 -259 1 15.5486 9.75906 12.4999 -0.653644 29.4777 3.96245 -260 2 15.1521 10.5891 12.1135 7.41979 -25.1975 16.8694 -261 2 15.9641 10.0301 13.3422 -9.48671 -5.05259 -12.6364 -262 1 16.5044 12.5382 5.51299 -3.50049 1.7151 -41.7779 -263 2 16.2902 13.4721 5.54585 0.30498 11.7411 21.1442 -264 2 16.3754 12.4207 4.53497 7.77761 -11.637 24.1999 -265 1 6.32544 9.92844 0.21289 -23.4091 -5.64021 -11.1485 -266 2 5.58447 10.3552 0.689761 9.59747 -6.57127 -5.34636 -267 2 7.10511 10.1371 0.71679 14.7949 3.34633 14.2781 -268 1 12.1134 5.97718 4.01208 -22.8865 -14.7559 9.656 -269 2 12.2541 6.73773 3.46345 4.76282 13.7738 -16.8186 -270 2 11.1454 5.80116 3.92348 22.2207 -1.187 3.16864 -271 1 0.310021 12.9061 0.00438974 -4.95288 1.79463 -7.14095 -272 2 18.578 13.473 0.695812 6.768 -1.51286 0.947724 -273 2 18.4929 13.1888 17.8371 0.864006 -6.25549 9.7975 -274 1 3.57649 0.0893425 8.67318 10.7138 1.44606 -23.5182 -275 2 3.53585 18.3471 7.78602 0.204258 -6.73647 -0.0210952 -276 2 2.75019 0.556646 8.71194 -17.5671 6.50862 13.0872 -277 1 7.32229 17.553 4.46711 -1.8346 22.7033 -6.51397 -278 2 7.49747 18.5341 4.60164 1.92735 -36.6431 -12.1684 -279 2 7.43093 17.3591 3.50845 0.44318 8.65947 16.4016 -280 1 9.23372 17.1692 12.2368 -1.40541 18.7929 10.7586 -281 2 9.17923 16.5713 11.4947 6.54031 -16.824 -6.24154 -282 2 10.1445 17.1937 12.5849 -6.50468 -4.83213 -2.69749 -283 1 13.3883 13.1392 7.89062 -8.44361 -29.718 12.0449 -284 2 13.2983 12.3346 8.48336 5.26587 25.8846 -16.8323 -285 2 14.1176 13.673 8.22732 -1.02664 3.48474 5.19869 -286 1 14.8313 2.83639 15.4549 13.5448 -0.0778016 6.35676 -287 2 14.1767 2.18003 15.2177 -4.87233 -8.03631 -4.89691 -288 2 15.4971 2.82305 14.7488 -5.52573 3.83225 -1.21536 -289 1 9.88985 15.6498 16.9162 -1.5178 12.6863 -12.8881 -290 2 10.4068 14.8878 16.6522 -4.3383 -15.6303 0.424585 -291 2 9.57752 15.4658 17.7984 -6.29913 -5.39682 13.2163 -292 1 11.1832 8.45041 16.604 0.69795 7.62392 -5.91094 -293 2 10.4558 7.91494 16.2714 -2.08228 -2.22425 -3.83894 -294 2 11.7364 7.86183 17.1086 3.16052 -9.92137 8.33691 -295 1 3.98058 18.2281 16.8796 4.69725 -6.17709 8.80305 -296 2 4.47544 17.5796 17.4031 -3.04366 -6.21568 -3.2578 -297 2 4.2975 0.415113 17.2284 -3.71051 8.24157 -1.82763 -298 1 2.31186 4.29334 8.90298 15.9673 -19.5394 32.2139 -299 2 3.25638 4.01729 8.88792 -18.4415 10.5974 -6.3491 -300 2 2.00846 3.99585 9.80326 5.50039 13.6474 -24.2252 -301 1 9.93626 10.4071 9.85717 -7.16433 6.26663 -15.7674 -302 2 9.36967 11.1624 9.60099 8.89086 -7.49456 6.1891 -303 2 10.0442 10.3828 10.8072 -0.648607 3.91668 13.0823 -304 1 9.8312 0.910661 10.8223 11.6198 7.73817 -5.63486 -305 2 9.46664 0.0599513 11.0613 -12.5627 -8.03565 7.40448 -306 2 9.23233 1.33675 10.1908 -3.5905 -1.89286 -1.84539 -307 1 9.13587 15.2239 10.1542 8.27875 -9.17261 13.8125 -308 2 8.75897 15.8188 9.50902 -6.94043 7.83547 -6.48358 -309 2 8.46187 14.5466 10.3059 -2.40816 2.69742 -4.7236 -310 1 0.685213 9.67274 10.114 -7.63752 22.5158 18.5003 -311 2 0.719625 10.5209 10.6443 4.69174 -21.4783 -21.4849 -312 2 1.56632 9.47392 9.79675 4.15873 2.44002 -0.184199 -313 1 17.1428 4.74332 7.9842 -7.49261 0.0436566 15.7002 -314 2 16.4923 5.43036 8.24486 9.33931 -9.59151 -5.74994 -315 2 17.1543 4.09081 8.70481 -1.62938 8.73821 -5.69634 -316 1 14.873 14.5838 0.184633 -12.5055 -0.863041 8.47648 -317 2 15.4452 15.0773 0.785336 2.49238 5.2379 -3.7088 -318 2 14.1221 14.3325 0.749692 6.56524 -1.80757 -8.31994 -319 1 3.93739 11.0893 9.63941 -1.02455 -14.3236 -20.6383 -320 2 3.83455 11.1931 10.5803 -4.40039 8.60569 15.1914 -321 2 3.22961 11.5882 9.19534 2.92088 3.20496 1.27781 -322 1 11.4787 10.7372 1.42758 24.3197 -0.772389 9.7934 -323 2 11.803 11.5915 1.09275 -4.97826 -3.71445 3.9898 -324 2 10.5984 10.6629 1.1011 -26.1902 -1.18673 -8.43185 -325 1 13.1873 7.21634 12.6041 -15.1781 -16.7535 7.59792 -326 2 14.1321 7.04558 12.6338 7.66113 -4.04391 -1.22332 -327 2 12.7625 6.33802 12.7657 6.99529 16.5731 -3.03327 -328 1 9.70202 2.01155 0.798053 14.7354 3.6785 18.4689 -329 2 8.80874 1.78739 0.563168 -12.7542 -2.84597 -8.5823 -330 2 10.1462 2.35336 0.0231027 2.1886 1.53799 -6.67264 -331 1 10.5601 13.4177 4.61479 15.5689 5.45852 21.4774 -332 2 11.4398 12.9929 4.68798 -8.71776 0.745444 -2.53542 -333 2 10.4627 13.8549 5.48714 -1.1208 -2.16649 -13.1077 -334 1 14.6135 1.64587 10.9888 -15.9483 2.47769 1.03658 -335 2 15.3653 1.14828 10.6398 3.3395 9.35485 -7.37665 -336 2 14.6055 2.55489 10.6162 9.33106 -12.1869 7.67578 -337 1 14.4205 12.072 11.5247 -14.0438 -11.3661 -21.2086 -338 2 15.2325 12.1783 11.0185 5.83651 11.9615 0.736203 -339 2 13.7775 11.7491 10.8405 12.2041 8.47933 23.407 -340 1 8.16075 5.17074 9.91542 -32.2508 22.4833 15.2463 -341 2 7.26447 5.43351 10.2769 29.6925 -9.34554 -9.10024 -342 2 8.08912 4.23235 9.75273 2.68018 -15.2376 -3.85437 -343 1 1.73754 17.0197 18.4251 17.7604 24.8388 -20.6387 -344 2 2.31535 17.5448 17.7835 -20.2636 -19.608 22.2942 -345 2 1.91865 16.0976 18.2314 3.71033 -9.13614 -1.37747 -346 1 1.38218 17.4352 15.3141 25.6123 -1.10879 -8.05345 -347 2 1.40837 18.2867 15.7687 -7.1514 0.273564 3.63966 -348 2 0.483975 17.1212 15.2601 -14.2857 -2.70278 3.05549 -349 1 3.46713 5.71669 6.03858 -5.21329 -0.208659 9.269 -350 2 3.09179 6.35885 6.66621 -4.29108 -6.04245 -5.71481 -351 2 3.94628 6.22951 5.39233 13.1871 8.33197 -8.25473 -352 1 12.7108 9.52885 14.2713 4.43437 -19.6411 -8.16456 -353 2 13.1132 8.73466 13.871 -3.04318 14.9787 -8.97539 -354 2 12.4252 9.15135 15.1011 -11.0135 5.38653 13.5706 -355 1 4.12803 15.1962 7.19495 12.4066 -8.66704 -3.75127 -356 2 3.59847 15.8823 6.77325 5.03517 9.17322 -2.57748 -357 2 5.08076 15.3227 6.96437 -18.0652 5.77836 0.725546 -358 1 0.842345 8.89099 15.1297 2.31502 -25.1166 0.479797 -359 2 0.506769 9.78853 15.0967 4.66165 8.13805 -4.97691 -360 2 1.56169 8.8202 14.4757 -4.5077 5.49756 1.76436 -361 1 12.9722 8.22706 10.1223 30.4908 -35.0116 2.62512 -362 2 13.7358 7.69898 9.75664 -18.6412 19.8455 -0.140907 -363 2 12.9154 7.83668 11.013 -6.3959 11.2287 -1.2259 -364 1 15.209 8.0796 3.38747 1.18456 -35.8933 6.76248 -365 2 14.5518 7.57266 2.91157 -10.3511 16.9608 -18.4151 -366 2 15.3784 7.42989 4.0872 14.9983 19.582 11.3682 -367 1 17.1108 6.70081 18.626 -14.4882 23.5427 -0.564853 -368 2 16.573 5.93167 0.182006 3.19594 -3.93797 2.70551 -369 2 16.4292 7.40436 18.4932 17.3888 -11.7094 -2.73385 -370 1 8.93374 7.05508 7.97597 -34.6157 -22.4872 9.48373 -371 2 9.83531 7.32727 7.97774 29.5921 7.62374 2.22252 -372 2 8.80811 6.41093 8.72029 6.54491 10.6746 -16.3243 -373 1 12.5312 0.423333 1.1911 6.44852 -9.8202 9.01884 -374 2 13.2753 0.834119 1.64897 1.63592 5.99122 -1.78887 -375 2 12.9315 0.0607692 0.396252 -6.77848 2.89528 -3.69601 -376 1 5.75537 14.98 14.4363 12.3645 2.0371 -4.21343 -377 2 4.82148 15.0687 14.6213 -16.3449 4.01416 5.01671 -378 2 6.0882 15.8478 14.162 -3.83146 3.10822 0.706071 -379 1 3.69037 6.49544 1.72037 -3.07239 6.81288 -7.41536 -380 2 3.43088 7.36249 1.36332 1.27628 -12.1507 -2.18765 -381 2 3.67848 6.67228 2.6574 4.23334 -3.71069 10.2966 -382 1 3.82256 11.2843 12.3046 -0.864415 -4.77059 0.0245619 -383 2 4.71622 11.5939 12.5181 -0.579536 5.4381 2.57712 -384 2 3.18979 11.9063 12.6819 -0.230908 7.2683 5.57723 -385 1 5.33149 3.8717 15.6726 -21.611 69.2317 6.1195 -386 2 6.02506 3.28248 15.4947 35.9646 -33.3333 -4.61122 -387 2 5.75271 4.79171 15.6869 -18.1046 -35.0984 -1.75377 -388 1 13.9893 10.0773 4.7789 22.4286 4.91544 -48.853 -389 2 14.2819 9.66907 5.58109 5.23319 -9.97863 19.9681 -390 2 14.5573 9.69868 4.0468 -17.0356 6.64649 24.2901 -391 1 7.62039 17.28 9.03644 -1.79817 -13.3385 2.54351 -392 2 6.82618 17.452 9.57294 2.68689 7.94648 -2.92213 -393 2 7.87136 18.0666 8.53956 -0.560867 8.99315 -4.02364 -394 1 4.58082 14.4709 3.89205 3.13293 1.46958 -13.0867 -395 2 4.66344 15.3386 4.31009 -0.0981131 -0.860678 2.59791 -396 2 4.56838 13.761 4.54421 -0.137719 -0.424919 8.72805 -397 1 14.11 7.4138 15.8858 20.156 9.8447 -1.08692 -398 2 14.9007 7.50898 15.3123 -12.2349 -4.78906 9.9244 -399 2 14.35 7.89712 16.7003 -4.15301 -9.39138 -6.29924 -400 1 2.88871 18.3931 1.90601 -10.0733 25.2579 5.70796 -401 2 2.56074 17.6209 1.45485 -4.97176 -8.65563 -11.6917 -402 2 2.08224 0.29716 2.10455 27.8478 -15.7521 2.2348 -403 1 8.03506 1.57584 4.43091 11.32 6.26446 5.75526 -404 2 7.34029 2.01323 3.92479 3.96785 0.109851 -4.32136 -405 2 8.88243 1.87946 4.04557 -12.5027 -7.48646 4.71123 -406 1 2.59748 14.2159 17.7933 -41.9258 1.66076 -8.0641 -407 2 1.85609 13.5734 17.9588 19.2075 16.8599 2.55802 -408 2 3.39352 13.7425 17.9784 23.6145 -16.2032 6.42715 -409 1 1.02442 1.99672 13.9281 17.4639 2.95853 -13.5386 -410 2 1.00308 1.87917 14.8709 4.63864 -6.80727 18.6653 -411 2 18.7659 2.1043 13.6716 -21.6962 3.88026 -3.66909 -412 1 4.27686 0.20187 13.9044 10.5162 4.04171 -16.044 -413 2 5.10447 18.3372 13.9403 -4.05013 6.4475 2.1433 -414 2 3.72354 18.5099 14.5979 -6.57077 -5.71295 14.511 -415 1 7.38305 1.01959 18.4815 -37.4449 7.12948 8.58409 -416 2 7.61008 0.74545 17.6036 5.58611 -6.30497 -21.5445 -417 2 6.41018 1.26146 18.4662 31.347 -10.6343 7.25927 -418 1 15.7518 18.4403 13.8831 -5.31168 6.41878 -7.08883 -419 2 14.7988 18.525 13.6912 13.3949 -2.54728 9.28792 -420 2 15.9153 18.5927 14.8217 -8.96218 -2.42265 4.9219 -421 1 10.3004 4.59906 16.2125 -26.9192 -42.5531 9.44494 -422 2 11.2318 4.75068 16.1287 26.1471 2.80018 1.93501 -423 2 10.2211 3.60629 16.3773 -0.864587 37.9812 -10.9337 -424 1 15.8848 17.7109 4.47524 -26.0192 -17.7161 -6.69824 -425 2 16.416 18.4558 4.72522 12.9982 18.1701 2.23702 -426 2 14.9575 17.9834 4.62838 14.848 -2.41832 2.25768 -427 1 6.86545 17.6577 14.0262 -6.12412 -8.41921 6.45462 -428 2 7.47866 17.6693 14.7646 2.09746 6.93436 13.8689 -429 2 7.44902 17.4838 13.2997 11.4214 -0.145135 -19.8537 -430 1 13.1703 6.41318 6.52816 -11.7529 -0.316938 -15.1514 -431 2 13.9829 6.90375 6.37155 7.88734 -3.14145 2.99861 -432 2 12.7537 6.33512 5.64174 6.34445 -4.78434 12.9923 -433 1 7.85335 2.30114 9.49646 -14.1039 1.33546 -28.6309 -434 2 7.23443 2.06415 10.1901 -3.07143 2.26257 12.1486 -435 2 7.33833 2.15664 8.66054 15.7097 0.546065 18.7565 -436 1 15.1664 14.7315 13.8676 -13.4222 3.7476 -0.777794 -437 2 14.8716 15.1233 14.7167 4.70885 -6.20173 -11.3706 -438 2 14.4912 14.9291 13.1959 7.90291 2.0321 9.20294 -439 1 9.36434 8.4507 3.85153 -5.45323 -8.44175 -9.3174 -440 2 10.195 8.80526 4.18009 6.07261 4.07641 1.89943 -441 2 9.48655 7.50041 3.73575 1.17631 -1.18483 4.07146 -442 1 17.585 13.5529 16.4533 28.0827 9.29223 -15.0932 -443 2 16.6463 13.3857 16.5308 -13.0105 5.34146 -4.98563 -444 2 17.7372 14.3421 15.8749 -12.9185 -11.1551 11.5131 -445 1 5.00344 10.4544 2.83444 15.3623 2.39709 8.30796 -446 2 5.84337 10.0047 3.04968 -12.8086 4.14038 -0.288119 -447 2 4.84487 11.029 3.60723 -3.54173 -2.25206 -8.41364 -448 1 3.64071 8.37653 9.83285 -3.63557 -2.42467 19.3481 -449 2 3.86873 9.30617 9.70655 -0.364806 7.27712 -2.43853 -450 2 3.42279 8.30417 10.789 5.82381 -0.771913 -15.5307 -451 1 16.012 6.92262 5.85834 3.10414 -0.205141 -1.95775 -452 2 16.7064 7.38617 6.35888 -2.44937 -6.94247 -7.87698 -453 2 16.3342 6.01666 5.66219 -6.01431 14.0457 5.91674 -454 1 15.3573 7.28861 8.91428 -7.73552 23.9623 -29.5509 -455 2 15.9286 7.60908 9.59449 17.6585 1.69923 20.6432 -456 2 15.3281 8.05346 8.27817 -7.4668 -29.0722 12.6462 -457 1 6.23444 12.7891 12.7562 -16.1216 7.07791 -6.67583 -458 2 7.04381 12.3675 13.028 12.7717 -9.63916 7.37694 -459 2 6.08648 13.5082 13.3891 2.20208 -1.21591 -2.77254 -460 1 12.1275 4.60499 13.1618 30.5736 27.4894 8.79026 -461 2 12.1815 4.60813 14.1323 1.45244 -2.14521 -6.91324 -462 2 11.4269 4.052 12.8891 -30.6572 -22.7655 -2.33684 -463 1 11.4418 8.05897 7.8749 4.39649 -6.11408 4.26725 -464 2 12.0054 7.38105 7.40707 -4.89778 19.9996 19.2901 -465 2 11.7913 8.23063 8.79017 -1.61454 -12.0828 -25.9053 -466 1 16.8934 10.7552 7.64898 5.958 -15.487 6.46706 -467 2 17.5218 10.034 7.45777 0.434714 4.65833 3.39608 -468 2 16.8005 11.223 6.82193 -0.787623 15.1873 -12.5781 -469 1 5.19162 18.0101 10.6182 -11.7475 -9.51575 -5.50364 -470 2 4.6689 17.2843 11.0141 12.267 13.7571 -4.22389 -471 2 4.61649 18.3258 9.88348 13.0529 -7.1725 20.3587 -472 1 7.61953 17.4141 1.49962 -5.28373 3.7131 11.8258 -473 2 8.17503 16.7132 1.19553 7.57367 -21.9054 -5.9523 -474 2 7.57614 18.0024 0.755384 -3.403 20.0604 -6.05803 -475 1 1.93154 12.9424 13.6297 4.26026 1.62766 0.165619 -476 2 1.31807 12.4855 14.2164 3.08324 -4.19991 0.575461 -477 2 2.34989 13.6289 14.1741 -4.48691 2.36366 -2.57882 -478 1 9.34851 6.7636 14.8211 -2.90069 2.43692 -15.7898 -479 2 9.659 5.88476 15.1078 3.08688 5.56829 -7.87962 -480 2 9.50722 6.89182 13.8456 0.484936 -6.74561 22.7152 -481 1 15.2631 4.37275 10.7209 -0.391742 -1.67154 5.71992 -482 2 16.1506 4.03655 10.897 1.37527 -0.677682 -8.66997 -483 2 15.1154 4.97006 11.4686 -2.24536 -2.27818 -6.11794 -484 1 11.4934 6.22632 -0.0241442 -6.06296 -11.7718 -8.66306 -485 2 11.6483 5.30933 -0.309107 4.27028 6.28431 2.83608 -486 2 10.5284 6.3165 18.5406 6.28072 6.83613 2.73886 -487 1 18.4725 11.4275 14.8977 -1.36673 1.10287 -33.3787 -488 2 18.0559 11.937 14.1605 1.63397 -11.827 9.6186 -489 2 18.3384 12.0011 15.6307 -5.5196 20.2825 24.8766 -490 1 7.17852 9.29091 7.31266 -12.1778 -5.70725 -5.55247 -491 2 6.76293 8.42612 7.50122 5.49043 12.248 4.67896 -492 2 8.1168 9.11866 7.26453 10.5183 -1.31775 0.108346 -493 1 18.3399 15.3762 12.1294 6.77425 7.85663 0.444206 -494 2 0.624383 15.5788 11.9067 -6.5428 -1.83873 1.38378 -495 2 17.7957 15.9125 11.5264 -1.63248 -5.99386 0.103645 -496 1 16.5386 4.34911 5.2503 -38.2238 -21.0357 51.9327 -497 2 16.6701 3.96728 6.16388 -6.69454 12.6485 -26.055 -498 2 17.3775 4.32019 4.85382 41.1543 5.3392 -22.1831 -499 1 17.7341 3.08223 10.7755 -2.39486 19.3144 10.8573 -500 2 18.6554 3.32717 10.9901 -9.67157 -6.39923 -2.68969 -501 2 17.7406 2.18791 10.4534 3.10102 -17.6187 -9.33289 -502 1 12.3347 18.6584 10.1394 22.1152 -18.6094 -11.1242 -503 2 11.4269 0.285024 10.28 -5.50333 15.1479 5.74269 -504 2 12.9381 0.769801 10.2484 -7.53185 0.18177 2.36971 -505 1 10.4414 9.72052 12.5804 5.49259 18.5488 2.65475 -506 2 11.2372 9.86145 13.1232 -3.33328 -5.81976 -2.33485 -507 2 10.4983 8.8205 12.2639 -0.9125 -13.8337 3.2089 -508 1 0.576047 2.60181 7.2501 -1.65995 13.3288 -12.3458 -509 2 0.268028 3.48996 7.49944 2.28387 -7.91724 -1.96879 -510 2 1.05133 2.26453 8.01425 -2.57801 -1.32252 3.73717 -511 1 0.35756 15.2681 6.96461 -6.18578 -18.242 -64.2832 -512 2 0.656709 14.9904 7.8095 9.46814 -3.47663 35.1726 -513 2 0.533918 14.474 6.37104 -3.56161 26.9089 25.8891 -514 1 17.0554 6.8805 14.912 24.4713 -1.83906 11.5387 -515 2 17.8121 7.50971 14.9246 -13.4777 -6.95308 -2.51376 -516 2 17.3666 6.12061 15.452 -8.01529 8.59931 -8.57008 -517 1 9.11821 12.4896 7.9597 -39.3936 14.7629 -4.46817 -518 2 9.45619 11.6923 7.5591 7.68398 -14.1787 -12.8233 -519 2 8.20522 12.6235 7.56541 34.2702 -5.52337 13.9854 -520 1 1.14934 1.62531 2.7512 -10.6975 -16.4856 11.3042 -521 2 0.557887 1.95566 2.07466 1.95024 15.5996 -8.59751 -522 2 1.5216 2.35039 3.25303 6.14281 9.13632 1.51194 -523 1 4.18801 15.1235 9.83797 -4.3571 13.9944 -8.49019 -524 2 4.15169 15.4364 8.91421 -7.63033 -5.74015 13.5827 -525 2 5.04261 14.6826 9.83518 3.69587 -3.91806 9.7151 -526 1 7.38616 2.29059 14.8987 -4.38475 3.80451 -15.2317 -527 2 7.23636 1.51405 14.3418 -1.55041 0.530275 6.25745 -528 2 7.45512 3.02747 14.2682 8.09838 -6.66607 2.4433 -529 1 18.2954 14.5248 2.13868 21.7335 16.5649 1.154 -530 2 0.530315 14.9412 2.32201 -13.6123 -15.8317 -3.76049 -531 2 17.7186 15.2797 1.96871 -6.10103 1.83177 1.59348 -532 1 10.0818 2.68123 12.8993 0.213282 -13.011 -16.4533 -533 2 9.9804 2.00538 12.1749 2.58274 17.6757 17.7308 -534 2 9.30115 3.24961 12.8455 -1.77409 -0.0668197 -1.90377 -535 1 2.92042 8.79199 13.1038 3.60331 12.5418 -6.85933 -536 2 3.19747 9.71233 12.8787 -2.51528 -19.5049 2.84802 -537 2 3.74925 8.3139 13.2755 -6.12566 -1.47569 1.35688 -538 1 3.2826 8.6043 3.78787 -1.06696 -30.5523 53.3514 -539 2 3.6648 9.24286 3.23576 21.5217 31.7748 -30.2126 -540 2 3.73659 8.75462 4.6619 -18.3855 -4.45548 -24.3241 -541 1 5.99503 7.23605 8.68049 -5.70462 -6.01689 -7.52618 -542 2 5.88732 6.32464 8.37432 -5.09887 -1.13221 5.21957 -543 2 5.15444 7.50455 9.08765 4.58913 -3.02319 1.70333 -544 1 14.8694 1.67632 1.824 4.95495 -3.07302 -21.4612 -545 2 14.923 2.54765 2.20438 -6.9063 6.82762 18.8127 -546 2 15.1986 1.83723 0.92353 -1.55356 -7.84532 7.79991 -547 1 8.71318 14.9586 0.633889 5.3189 4.72704 12.5337 -548 2 9.41548 15.0137 1.3229 -12.9747 -8.59069 -7.21106 -549 2 7.9574 14.4505 1.00218 9.17218 5.81258 0.251254 -550 1 15.3522 1.50057 7.22863 -1.61242 -14.2743 -3.26221 -551 2 14.7819 0.961058 6.63945 7.54361 11.5891 10.8038 -552 2 14.804 2.18796 7.6304 -1.95204 4.928 -5.75504 -553 1 4.88832 12.8638 18.4669 14.1773 6.076 10.5021 -554 2 5.16486 12.9634 0.754115 -2.57074 -3.9589 -10.7447 -555 2 5.64539 13.2163 17.9734 -6.87045 1.01425 -0.872896 -556 1 15.3658 8.71105 18.1022 0.313753 1.99863 -15.4271 -557 2 15.6825 9.25538 17.3367 -2.33671 -6.91366 23.9636 -558 2 15.2177 9.29821 0.21527 -1.89476 6.92048 -0.597105 -559 1 12.0025 3.14868 18.2874 -4.08601 9.85731 -2.22671 -560 2 12.1144 3.11564 0.603374 4.33643 -8.86024 -4.9595 -561 2 12.4653 2.40747 17.863 0.0624807 -1.52737 7.22507 -562 1 13.2135 12.7035 5.12884 9.73413 0.384952 2.90661 -563 2 13.7 11.8654 5.00774 -9.98906 4.00813 0.0328844 -564 2 13.4141 12.9701 6.04548 -3.79483 -4.91087 -6.97232 -565 1 6.18903 7.09371 0.234798 3.60985 -26.8596 -14.0682 -566 2 6.2071 8.04594 18.8061 -7.0012 19.4313 6.00448 -567 2 5.26363 6.79856 0.279731 4.49735 8.94005 5.55961 -568 1 17.7003 15.89 14.853 -18.1963 11.2058 -20.3772 -569 2 16.8346 16.3247 14.8039 6.19322 -4.54728 12.6057 -570 2 17.8435 15.7325 13.9057 13.4875 -6.37623 4.18836 -571 1 13.0834 0.870867 16.8965 -0.161813 1.3846 -1.86612 -572 2 14.0072 0.582211 16.892 1.10768 1.72224 0.871652 -573 2 12.5754 18.726 16.653 1.71204 -0.315799 1.62538 -574 1 10.8945 14.507 7.48359 31.9827 12.7774 -14.5262 -575 2 10.2535 13.8684 7.76101 -18.1255 -14.8352 9.6937 -576 2 11.748 14.0397 7.49435 -7.74827 -1.48019 1.36014 -577 1 17.7521 8.40099 2.11802 -4.68381 10.101 13.2464 -578 2 16.8759 8.32923 2.50971 -7.38706 6.94009 5.95596 -579 2 17.7532 7.67887 1.5098 2.25561 -17.6604 -22.6471 -580 1 12.5231 7.84865 2.0094 -2.30264 15.9804 1.37474 -581 2 12.1379 8.74758 1.97393 9.3167 -10.0751 -1.70323 -582 2 12.325 7.4571 1.14918 -4.66948 -5.90928 2.89896 -583 1 11.972 14.5025 10.3451 -2.96888 12.9379 -2.77484 -584 2 12.1874 14.7132 9.42348 -1.74009 -6.18971 10.5862 -585 2 11.0277 14.706 10.4449 2.87573 -2.36207 -4.30421 -586 1 6.71227 6.84952 15.5806 25.6498 -3.78319 22.6581 -587 2 7.68828 6.90632 15.3859 -23.8939 0.442938 5.1849 -588 2 6.62279 7.02219 16.5478 -0.830995 -1.23763 -22.0679 -589 1 7.92027 4.40739 13.1357 7.88731 17.7005 28.4833 -590 2 7.20639 4.70613 12.563 -5.96959 3.19417 -4.54574 -591 2 8.05118 5.13552 13.7952 -2.84521 -16.8776 -20.7331 -592 1 13.2899 12.2294 14.3537 -3.3223 6.18653 6.3482 -593 2 12.9901 11.3268 14.1873 4.87208 -4.78833 3.90165 -594 2 13.6879 12.5058 13.5223 1.91273 0.0234059 -4.06458 -595 1 14.5389 9.51264 7.32918 -7.01434 -27.1539 -11.6023 -596 2 15.2763 10.0624 7.53312 20.4851 16.6908 8.43718 -597 2 13.8132 9.80854 7.861 -14.3264 8.19434 11.2695 -598 1 12.68 16.8773 3.29092 2.11558 25.6431 -8.94229 -599 2 12.7733 17.3894 4.13219 -1.2803 -9.72294 -18.9636 -600 2 12.6793 17.5234 2.53176 -0.650571 -10.0569 23.6182 -601 1 0.970813 7.05439 17.3478 19.6691 8.71735 -9.44801 -602 2 0.0997442 7.2771 17.6294 -27.888 -7.65058 15.2547 -603 2 1.07493 7.61203 16.5711 5.30897 3.90939 -5.98442 -604 1 13.0218 4.86702 15.7977 -14.5255 -22.5737 -0.430567 -605 2 13.6652 4.12206 15.7771 -2.73243 23.3382 0.768668 -606 2 13.4898 5.70142 15.8866 10.098 7.61534 -0.732483 -607 1 2.35004 3.40025 5.07686 -12.6408 -17.529 -7.45963 -608 2 1.84891 3.15034 5.87751 4.27568 5.0167 -3.29201 -609 2 2.74325 4.26374 5.21682 1.23402 6.29722 12.7184 -610 1 8.14417 10.9001 13.7499 9.28616 -30.1931 45.6744 -611 2 7.9506 10.3552 14.611 8.46781 36.9232 -44.8577 -612 2 9.00813 10.5574 13.4404 -10.6035 2.99953 -2.14266 -613 1 13.0821 1.49083 13.2989 5.3891 9.28887 -24.1834 -614 2 13.7872 1.3627 12.5959 -25.8284 12.5052 17.3021 -615 2 12.4896 2.22352 12.9857 19.0093 -19.6589 8.86348 -616 1 6.62484 13.6674 2.02561 -2.30013 1.61314 -5.1998 -617 2 5.94206 14.1599 2.51404 7.05284 -6.38204 5.2583 -618 2 7.12137 13.1184 2.65568 -4.11309 1.61678 2.96157 -619 1 15.7857 6.33001 12.4874 9.47505 -1.37582 18.5865 -620 2 16.2809 6.76838 11.7933 3.97273 7.7159 -2.96061 -621 2 16.3586 6.41799 13.2831 -12.689 -0.09302 -8.30077 -622 1 16.7471 0.613682 9.52771 11.5447 -14.6629 17.7173 -623 2 16.7567 18.2848 9.57147 -3.7535 4.88819 4.87116 -624 2 16.43 0.840462 8.66213 -13.2327 5.78697 -22.1845 -625 1 6.19152 11.681 8.24955 3.80355 -8.99636 -2.81467 -626 2 5.36879 11.4903 8.73023 3.19436 -10.2741 -4.0588 -627 2 6.55865 10.8405 7.8788 -10.8203 9.76695 14.653 -628 1 2.78766 8.56788 0.409413 -52.7319 2.11899 -11.855 -629 2 2.08185 8.03903 18.552 32.3713 20.2249 14.5342 -630 2 2.26775 9.27739 0.866586 13.6595 -12.5773 -9.56289 -631 1 10.1003 10.2385 6.61376 -10.8952 5.58665 6.62413 -632 2 10.4921 9.47201 7.04387 8.70092 -2.05853 1.95229 -633 2 10.597 10.3787 5.79806 -1.31095 -2.00825 -0.431677 -634 1 6.84539 15.7603 6.76774 -1.32488 -8.5888 0.285168 -635 2 7.15445 16.2386 7.5582 -1.07119 -0.859265 -6.52036 -636 2 7.16186 16.249 5.99512 -0.908646 8.8198 -0.167177 -637 1 6.64088 12.8596 5.99362 6.27305 7.11444 -12.0385 -638 2 6.74407 13.8044 6.07603 1.27228 12.7365 2.69296 -639 2 6.25078 12.5941 6.82297 -5.96354 -7.18103 4.5408 -640 1 16.6867 12.5722 9.84379 -3.64815 -5.06409 7.40683 -641 2 16.7505 11.8965 9.15556 3.82735 1.49832 -4.74998 -642 2 16.8024 13.43 9.4304 0.212763 1.2752 -2.86494 -643 1 6.31521 2.74143 2.73106 -6.87016 -8.03266 -4.4066 -644 2 6.55003 3.64872 2.52358 -0.655364 10.9132 -0.0341781 -645 2 5.98199 2.35933 1.9027 -1.39596 -0.0669143 5.2552 -646 1 10.642 2.89265 3.25205 -8.44131 -1.48195 -5.66324 -647 2 10.1183 3.68518 3.4139 4.92295 3.00907 1.37692 -648 2 10.2968 2.53281 2.41595 2.77965 2.00448 3.56419 diff --git a/examples/amoeba/dump.water_box.hippo.1.test b/examples/amoeba/dump.water_box.hippo.1.test deleted file mode 100644 index 33463a3a5d..0000000000 --- a/examples/amoeba/dump.water_box.hippo.1.test +++ /dev/null @@ -1,7227 +0,0 @@ -ITEM: TIMESTEP -0 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.67966 7.08769 17.9461 -19.3527 -13.639 6.25201 -2 2 7.80945 6.75579 18.2607 18.4949 11.1596 -6.01922 -3 2 8.72223 6.81424 17.0254 5.85599 -0.890166 3.45586 -4 1 18.5257 8.24445 6.83762 11.8085 12.5587 58.8481 -5 2 0.216892 7.89544 6.05003 10.8935 -14.9684 -50.5046 -6 2 0.444268 7.82601 7.5302 -15.2958 7.9793 -8.89884 -7 1 8.37906 18.5504 6.81463 25.5385 6.64228 -3.75624 -8 2 9.34042 0.098069 6.73406 -20.9151 -2.68951 1.38711 -9 2 7.93962 0.573676 6.26984 -0.656308 -0.308718 3.40946 -10 1 6.58995 1.84432 11.7198 46.6828 -15.9611 -12.5859 -11 2 5.88543 2.40231 11.9251 -37.6261 28.8114 18.1934 -12 2 6.18153 1.06275 11.3693 -6.58868 -16.6156 -5.55691 -13 1 7.1466 5.75358 2.33152 -56.1364 42.5085 -2.61462 -14 2 6.36812 6.12603 2.86268 40.1937 -23.4301 -4.21826 -15 2 7.02502 6.29465 1.5182 16.3021 -20.7884 10.9258 -16 1 16.2164 10.1388 16.1382 -32.0875 21.5958 16.7579 -17 2 16.9509 10.2747 15.5847 32.9015 -1.03241 -20.1636 -18 2 15.8498 11.0405 16.2399 1.98783 -14.756 2.71439 -19 1 10.6046 15.0374 2.30369 -8.13409 -25.494 -7.18668 -20 2 10.5292 14.3949 3.01849 1.41683 -0.603724 2.75561 -21 2 11.0236 15.78 2.70962 11.6057 19.8833 4.5888 -22 1 17.1624 8.24409 10.3708 13.0676 7.07862 9.73504 -23 2 16.5528 8.68798 10.966 -4.65968 7.37974 1.83434 -24 2 17.9421 8.82333 10.3208 -6.34155 -10.1937 -2.20396 -25 1 14.901 15.8652 16.3167 18.01 -6.87509 18.5636 -26 2 14.0225 16.1982 16.2525 -26.9236 12.7201 -6.50875 -27 2 14.9141 15.482 17.2099 2.63751 -6.05913 -7.59706 -28 1 12.1752 13.3771 0.408263 -11.3168 6.26442 9.98381 -29 2 12.0579 13.8465 18.23 5.67057 -4.50268 -16.0578 -30 2 11.6217 13.8904 1.00796 3.42507 -1.00312 9.73088 -31 1 9.27358 5.34243 4.05546 -35.2781 32.5984 16.8393 -32 2 8.64594 5.4665 4.83764 28.3783 -16.8163 -28.778 -33 2 8.74177 5.68615 3.30282 7.52493 -14.9247 9.48156 -34 1 1.83016 4.27673 11.6495 -21.1764 37.5598 -8.14901 -35 2 1.70328 5.22377 11.9391 6.02814 -28.7768 -8.29565 -36 2 2.40811 3.85345 12.2597 13.4728 -11.3181 18.3421 -37 1 1.96438 6.83299 8.3731 -11.1902 3.43717 -25.3738 -38 2 2.49614 7.21578 9.0563 9.35281 -0.190165 18.6039 -39 2 1.81128 5.90585 8.57354 7.84101 -3.79534 5.21373 -40 1 5.40557 4.38899 7.93274 -6.81526 4.7224 -2.63907 -41 2 5.53738 3.43895 7.78131 -7.79962 9.88898 0.533881 -42 2 4.75516 4.73491 7.29062 10.7858 -16.238 7.24535 -43 1 3.23 2.92842 17.5524 -0.538114 20.9936 16.7312 -44 2 3.93109 3.19827 16.9402 -0.965509 8.21721 4.01649 -45 2 3.00444 3.70897 18.1497 6.13449 -29.114 -23.6081 -46 1 7.4624 5.26283 6.13117 9.12728 4.25284 -1.73168 -47 2 8.02565 5.58849 6.88177 -24.817 -14.4341 -14.6054 -48 2 6.93508 4.45577 6.3254 16.0496 22.0303 12.0173 -49 1 9.77896 7.02384 11.9834 11.1205 -3.87253 23.9446 -50 2 10.2721 6.37256 11.5011 10.9222 -10.0302 -1.39678 -51 2 9.1532 7.31587 11.3499 -23.6433 13.1239 -20.7784 -52 1 14.1167 3.54999 8.03003 -30.7601 -1.60704 -37.9113 -53 2 13.4732 4.22413 7.73132 15.1608 -10.723 4.30178 -54 2 14.3809 3.80189 8.88487 12.8065 16.1495 34.678 -55 1 4.82329 17.2568 4.03846 -17.85 32.0436 -31.4073 -56 2 5.49315 17.973 4.01308 -7.71314 -24.6342 10.4391 -57 2 4.18746 17.5412 3.33843 10.9703 -13.5421 12.8553 -58 1 16.4918 16.6259 10.0493 29.9016 15.3745 -40.7533 -59 2 16.1673 16.3226 10.8594 -24.6786 -13.0437 37.8908 -60 2 15.9925 16.2084 9.33562 -4.01544 -1.82242 7.63759 -61 1 1.94489 4.93323 0.49791 29.1886 10.4759 3.59715 -62 2 2.55322 5.26335 1.2053 -17.2324 -10.4098 -15.9422 -63 2 2.08253 5.591 18.4408 -14.7087 -3.80383 3.81857 -64 1 11.816 13.3571 16.2711 -7.8083 1.12937 6.2001 -65 2 11.2371 12.6203 16.5671 13.3708 1.96491 -16.2063 -66 2 12.2446 13.1893 15.4079 -11.197 -7.32732 11.8633 -67 1 10.105 11.0651 16.9545 16.7158 -32.7784 1.37979 -68 2 10.5674 10.1947 17.1295 -14.0823 30.097 -5.45833 -69 2 9.25349 10.8067 16.5912 -2.99511 2.11526 2.57572 -70 1 11.7264 17.5421 13.4742 2.50122 -25.0158 -11.214 -71 2 12.2771 16.9836 12.8968 -8.91486 0.79877 6.23222 -72 2 12.1041 18.3936 13.317 1.59091 22.4782 2.42571 -73 1 6.33029 9.31911 12.2264 15.6898 -25.4439 -25.1534 -74 2 7.02603 8.96242 11.6353 -17.823 2.07037 1.33758 -75 2 6.81249 9.95941 12.7172 5.93051 22.1649 19.4162 -76 1 16.2187 12.7249 2.70186 -8.69715 -37.3569 7.82337 -77 2 17.0292 13.1566 2.50302 19.6243 18.7999 -9.68795 -78 2 15.4982 13.3357 2.61812 -8.61102 21.6356 1.57727 -79 1 0.637202 12.5625 5.84914 -32.6687 7.10288 -2.13707 -80 2 0.892312 12.5507 4.90771 -4.51242 -1.40786 13.4578 -81 2 18.3039 12.804 5.85329 37.5994 -4.88925 -6.97833 -82 1 5.19922 16.3781 18.5047 -7.71264 -0.634541 -12.9921 -83 2 5.80284 15.8543 17.9455 2.11468 10.7978 13.7187 -84 2 5.67034 16.9636 0.462296 7.23142 -5.58048 -3.24093 -85 1 0.510145 7.62945 4.0545 45.851 19.5686 -25.4796 -86 2 18.5719 8.14656 3.45296 9.61971 -16.7838 10.3831 -87 2 1.46496 7.74082 3.66917 -52.3954 -1.94356 25.3273 -88 1 3.14672 8.89584 6.52626 -54.2957 5.34018 -1.73828 -89 2 3.50609 8.59991 7.35294 9.18701 -2.26398 8.55435 -90 2 2.14573 8.92962 6.68203 45.3688 -0.563656 -9.64228 -91 1 7.30854 10.3037 16.1717 -0.0267506 0.140778 15.7468 -92 2 6.56213 10.4624 15.5802 1.32412 -0.384411 10.7132 -93 2 6.99303 10.278 17.1118 0.130505 3.94788 -23.0495 -94 1 11.1122 1.06968 4.98939 -2.83136 -16.8604 13.0177 -95 2 11.0776 1.97142 4.64864 2.2702 -4.31387 -11.6367 -96 2 10.7048 0.433547 4.37027 2.96408 14.9419 -2.56144 -97 1 4.45204 2.70061 13.2052 -8.32298 -31.9478 35.5434 -98 2 4.60333 3.05865 14.0914 -0.476624 15.5497 -15.2927 -99 2 4.38645 1.737 13.4626 0.207127 24.1129 -25.2696 -100 1 8.42792 10.0237 1.78469 -10.6267 -17.9408 16.848 -101 2 8.3405 10.6377 2.53622 4.43246 -2.98222 -4.40025 -102 2 8.49672 9.11244 2.17467 4.60711 29.3182 -9.45134 -103 1 10.5335 1.75383 15.546 -31.9958 -1.22726 0.532554 -104 2 11.3977 1.82718 15.9216 23.4057 -5.242 -0.0927752 -105 2 10.5608 1.78317 14.5837 3.34522 3.38855 0.282019 -106 1 2.77693 12.941 7.74821 -10.6415 2.34425 -2.27994 -107 2 3.28797 13.5733 7.23382 5.58977 0.334345 4.09149 -108 2 1.98704 12.8256 7.20013 5.22386 -8.52712 2.54059 -109 1 3.63517 11.6895 5.33963 -10.2259 -13.0028 -10.3717 -110 2 3.35385 11.0502 6.03137 4.73753 15.317 -16.6328 -111 2 2.8758 11.855 4.74058 11.3048 -4.09559 12.5928 -112 1 6.88803 14.474 16.8428 -13.42 9.46677 6.94107 -113 2 7.55973 13.8293 16.6383 4.5229 -1.76969 -1.40507 -114 2 6.60381 14.8838 16.0165 0.0834179 -9.06129 -0.120708 -115 1 14.1722 14.5374 3.41536 20.1951 -3.19134 -21.8839 -116 2 13.6514 15.2845 3.14096 -9.23852 13.3738 0.77613 -117 2 13.8512 14.2508 4.25439 -13.5451 -9.47926 16.7085 -118 1 8.28226 18.1809 16.0824 -9.43856 -15.6135 -5.07226 -119 2 8.77677 17.3494 16.3071 1.43839 31.5077 -5.33478 -120 2 8.7603 0.384816 15.9919 11.1327 -19.5096 4.24776 -121 1 4.73724 1.61643 4.90111 5.86874 37.6921 -30.6753 -122 2 3.96969 2.16837 5.15263 9.12039 -10.9712 -6.28456 -123 2 5.18465 2.1484 4.15475 -17.6049 -26.8232 41.7187 -124 1 15.1457 12.8616 16.4403 -17.0638 -11.2899 43.408 -125 2 14.6041 12.8692 17.2613 22.7365 8.03356 -12.6578 -126 2 14.49 12.6307 15.8136 -17.0236 -4.89604 -35.7974 -127 1 15.779 18.3837 16.786 48.5063 8.0766 44.3104 -128 2 16.5108 18.615 17.4688 -41.9285 -7.99937 -34.0327 -129 2 15.7694 17.4186 16.7687 -10.3466 2.2793 -1.1406 -130 1 1.1383 1.1331 16.5571 -3.54071 10.9478 5.94974 -131 2 1.96551 1.50352 16.9177 -15.9767 0.55296 -3.51275 -132 2 0.420521 1.53444 17.0916 21.5279 -7.8795 -5.43288 -133 1 18.0817 4.5907 15.863 15.8138 -19.1991 -2.64562 -134 2 18.5818 3.91936 15.3489 -11.6552 16.5822 9.8521 -135 2 18.5602 4.7339 16.6874 -1.16116 -1.56098 -3.02727 -136 1 12.22 16.9378 16.1148 -9.97587 -12.4224 57.0196 -137 2 11.409 16.6934 16.6676 29.0172 6.05041 -31.7989 -138 2 11.9646 17.3216 15.2917 -14.4882 2.9648 -22.1743 -139 1 15.8709 2.55221 17.9707 -3.56258 26.452 -16.7944 -140 2 15.7355 3.48355 18.2574 6.35046 -25.5765 3.86241 -141 2 15.6659 2.59235 17.0072 6.0189 -6.56803 19.8103 -142 1 6.70868 13.791 10.2637 1.94011 22.9489 3.02058 -143 2 6.59347 13.548 11.1958 0.710608 -4.45224 -7.92394 -144 2 6.58252 13.0514 9.6765 -3.73143 -16.591 0.344408 -145 1 10.146 18.2027 2.80372 16.894 35.9 -12.6825 -146 2 10.2207 0.331961 2.18345 -1.03174 -23.6422 14.9845 -147 2 9.26571 17.8868 2.67703 -18.7462 -7.34721 -7.1199 -148 1 2.97538 17.748 6.06078 -27.2244 1.77787 1.96995 -149 2 2.09399 17.6473 5.67013 1.23544 -3.46851 16.5241 -150 2 3.45883 17.8838 5.26396 32.1509 0.10025 -8.47089 -151 1 12.558 17.0134 7.97028 2.72879 -14.1128 -3.91884 -152 2 11.9572 16.2512 7.82085 4.20569 13.3061 15.6125 -153 2 12.4657 17.4524 8.83591 -10.4039 -6.95813 -9.08653 -154 1 14.8795 15.2862 8.28544 5.56082 -19.5077 38.9848 -155 2 13.9824 15.6136 8.40666 -1.04882 8.68143 -14.5015 -156 2 15.2312 15.4641 7.43118 2.2507 10.8701 -29.8329 -157 1 17.5429 18.3228 0.375372 -51.3852 -2.4253 -14.1847 -158 2 18.116 17.6308 0.128652 38.5367 -21.5025 -8.63787 -159 2 17.9698 0.288559 0.934677 24.3068 21.4661 19.9837 -160 1 0.910209 10.3712 1.41143 -2.71779 -52.992 43.3073 -161 2 0.158544 9.88347 1.87089 22.0109 19.7614 -26.7074 -162 2 0.565924 11.0969 0.944383 -22.7833 34.6337 -23.5778 -163 1 1.55407 12.175 3.31087 16.6578 22.9783 50.8488 -164 2 1.36245 11.4802 2.72234 -7.70692 -21.3552 -33.2695 -165 2 1.61623 13.0206 2.87285 -0.913798 3.83337 -14.7861 -166 1 0.543127 17.2543 4.88609 29.8094 34.6465 -52.7559 -167 2 0.11032 17.9772 5.31124 -19.8915 12.2203 12.8491 -168 2 0.420366 16.4266 5.2673 -10.0988 -43.8479 36.8786 -169 1 1.10053 1.01949 9.38768 20.7334 -4.84081 3.89797 -170 2 1.46081 0.575286 10.1589 7.03147 5.77442 11.7732 -171 2 0.265613 0.594128 9.34525 -29.6063 -3.3853 -10.3011 -172 1 16.8007 2.32783 13.2877 6.1037 15.2386 -31.0559 -173 2 17.0701 2.57314 12.3549 -10.0746 -10.076 30.4228 -174 2 16.4263 1.43993 13.282 1.60122 -3.62923 0.222317 -175 1 2.45231 15.8283 12.1942 27.8718 -10.8871 18.2649 -176 2 2.8623 15.5513 13.0537 -9.1784 7.03247 -27.4702 -177 2 2.91392 15.3801 11.4615 -3.34054 6.42182 7.24567 -178 1 16.435 15.531 5.9458 21.7194 38.3058 -21.2998 -179 2 17.3808 15.5177 6.20547 -16.0791 -6.59953 3.69269 -180 2 16.4147 16.2211 5.22063 -10.9707 -19.0563 26.084 -181 1 5.84547 5.02056 11.8065 15.5941 -20.7973 -13.2046 -182 2 5.55799 5.91374 11.8891 -11.5246 18.633 11.9833 -183 2 5.09 4.45915 11.9819 -3.94875 -1.81326 3.16792 -184 1 15.2214 4.86555 0.731755 -13.7826 -16.8748 28.0949 -185 2 14.6776 4.45845 1.47821 23.1081 18.7106 -26.9415 -186 2 14.6696 4.95834 18.5986 -11.4435 4.17379 2.92627 -187 1 16.3401 16.2933 2.11217 18.5695 -12.4905 -31.3072 -188 2 16.0666 16.7695 2.87319 -12.4192 21.1701 22.1863 -189 2 16.7601 16.9279 1.50378 -10.9162 -1.12869 10.7347 -190 1 0.305885 4.87877 3.79118 -7.51195 53.5881 20.4451 -191 2 0.299338 5.85541 4.09758 -3.10789 -46.5114 -24.0825 -192 2 1.16991 4.5635 4.03062 6.84312 -11.1831 1.05233 -193 1 2.92501 14.9782 15.0356 -4.41813 7.08234 41.1019 -194 2 3.0159 14.7264 15.9987 0.986861 -4.57119 -32.7424 -195 2 2.35392 15.7535 15.1247 6.41577 5.11218 -9.25191 -196 1 1.1115 14.5727 9.55731 53.3594 20.601 -11.7192 -197 2 2.08491 14.4157 9.46275 -24.0912 20.2308 -9.17401 -198 2 0.897072 13.7408 9.90248 -29.0631 -35.5955 19.1061 -199 1 13.6501 16.6688 11.5433 6.78983 17.7214 -9.74398 -200 2 13.4697 17.4567 10.9694 -2.9322 -22.903 16.7504 -201 2 13.5721 15.8897 10.9842 -10.359 0.342192 0.0202177 -202 1 4.73098 1.47842 0.720986 -5.29759 -7.25447 0.0447572 -203 2 4.27169 1.98826 0.034225 -5.56193 -3.14325 9.7343 -204 2 4.11741 0.788607 1.06182 6.25861 16.2271 -3.37713 -205 1 1.42158 18.4663 11.9139 -14.0127 27.0043 -17.9914 -206 2 1.21766 0.394331 12.6648 1.7087 -1.58128 0.41261 -207 2 1.94844 17.765 12.2423 13.0376 -22.9613 11.2697 -208 1 11.5498 10.1018 4.11619 27.4262 20.5676 -21.0421 -209 2 11.5687 10.5955 3.24216 -3.20948 -18.7647 28.9446 -210 2 12.4899 10.1059 4.45555 -29.515 -1.53007 -14.7279 -211 1 8.38254 12.182 3.76573 -26.3924 1.04105 6.81072 -212 2 9.25863 12.501 4.06076 -19.5654 3.48754 6.33549 -213 2 7.63736 12.4251 4.40785 41.4561 -5.4387 -17.0092 -214 1 14.3228 4.03714 3.29709 11.5996 0.889358 18.0886 -215 2 14.8928 4.14179 4.10547 -12.6664 -0.432988 -23.901 -216 2 13.4701 4.45558 3.48891 5.46089 -2.24129 3.2962 -217 1 5.58188 1.78199 7.50513 -33.666 -46.5708 42.0626 -218 2 5.0172 1.13958 8.12095 34.1345 40.5367 -42.64 -219 2 5.33078 1.59122 6.59529 1.4651 -1.13721 -3.53311 -220 1 17.9086 1.12503 4.88467 5.13037 -2.27617 -10.7476 -221 2 18.4038 1.54032 4.14207 -7.55128 -2.38968 19.1857 -222 2 17.6814 1.78344 5.55455 5.62983 -0.00428508 -6.93418 -223 1 6.83101 9.39303 4.49716 -12.9019 3.06885 -29.4929 -224 2 6.83675 9.57499 5.42715 5.2276 -1.57178 18.8103 -225 2 7.66807 8.99049 4.24996 8.60683 3.06936 7.19189 -226 1 2.71406 14.9654 1.962 -12.6433 -7.2797 -26.4735 -227 2 3.33343 14.7912 2.66354 11.3685 -5.36414 4.18623 -228 2 3.09502 14.6645 1.10257 -3.50464 10.9487 24.1748 -229 1 17.279 12.8803 13.1283 -18.5839 20.1434 9.0108 -230 2 16.4044 13.2339 13.3283 -9.51346 -21.2442 0.20606 -231 2 17.6948 13.7346 13.0834 29.6252 3.29486 -10.2855 -232 1 15.0196 10.5818 1.38314 -38.8036 -34.5801 -31.952 -233 2 15.5102 11.1963 1.85791 33.5109 39.8843 28.1173 -234 2 14.3351 11.0964 0.933298 4.14202 -6.46403 5.49191 -235 1 5.71789 6.95838 4.52856 4.11089 -29.6335 9.96606 -236 2 5.85266 7.87985 4.34179 3.17266 16.1428 1.23553 -237 2 6.44364 6.70841 5.13514 -12.5329 -0.461157 -7.94794 -238 1 8.12142 8.26262 10.159 -0.855146 6.49391 46.4818 -239 2 8.58519 8.93965 9.66877 4.4396 1.59282 -10.2318 -240 2 7.56021 7.74854 9.59836 -7.32825 -5.6782 -22.3885 -241 1 13.5311 18.2901 5.8079 -14.4364 -13.815 12.5854 -242 2 12.703 0.102298 5.56963 8.23181 2.14052 6.61043 -243 2 13.2939 17.6289 6.50758 2.60691 23.7973 -17.1373 -244 1 0.327324 2.56344 0.113251 2.62118 15.3541 1.11187 -245 2 18.009 2.52214 18.5736 10.3638 17.1812 4.70476 -246 2 0.724331 3.48299 0.160564 -23.8753 -26.7718 -0.881277 -247 1 12.6396 10.9599 9.76875 -60.0152 14.8867 -10.4701 -248 2 11.6552 10.7306 9.75031 40.0232 26.8927 -4.84212 -249 2 12.944 10.1383 10.0842 28.9404 -31.8014 10.6031 -250 1 0.789377 12.2851 11.08 12.3121 4.77193 16.7259 -251 2 18.4919 12.3017 11.2021 -18.2956 -1.72231 -7.06107 -252 2 1.09088 12.7637 11.8722 5.11265 -11.1183 -7.6011 -253 1 5.04567 7.2193 13.4912 -20.9717 -2.87687 -14.2941 -254 2 5.59899 7.84649 13.0247 8.94565 11.9067 4.64647 -255 2 5.48047 6.97898 14.3058 11.2978 1.34955 6.76892 -256 1 1.28609 6.99027 11.837 -50.3798 -70.0072 -12.7986 -257 2 0.481329 7.14037 11.2978 16.1889 0.462756 10.6855 -258 2 1.71601 7.79102 11.8803 28.8555 60.7949 7.07409 -259 1 15.4442 9.46712 12.3088 17.5488 35.5581 30.8368 -260 2 15.6103 10.4448 12.4444 -11.4156 -32.7422 -13.7105 -261 2 15.5582 9.10301 13.208 -6.0251 -0.167312 -17.6616 -262 1 16.6404 12.9744 5.44078 -0.477448 -16.7093 5.71929 -263 2 16.2955 13.8866 5.54247 6.71099 -18.3284 -17.4666 -264 2 16.51 12.593 4.54035 -5.5475 22.5864 15.6708 -265 1 6.17495 10.0683 0.210584 -22.0037 -7.52033 -29.8636 -266 2 5.35839 10.4511 0.557392 5.20282 -1.85407 -1.83494 -267 2 6.76092 10.0813 0.943985 23.8798 0.550264 15.5383 -268 1 12.3644 6.05734 4.04236 -20.6788 -35.4367 28.6454 -269 2 12.4738 6.70802 3.38308 -3.94744 31.282 -24.9442 -270 2 11.4212 5.77124 4.03221 20.7152 8.11174 -1.23853 -271 1 0.124733 12.8266 0.203961 1.72956 2.54106 -4.3392 -272 2 0.029974 13.5935 0.786871 -3.06107 -4.47794 0.0529132 -273 2 18.185 12.9963 18.0877 7.84157 1.57112 5.96497 -274 1 3.83931 18.5785 8.61972 17.9182 -8.56599 -14.1766 -275 2 3.58625 18.36 7.70531 -6.70328 -0.941099 8.10721 -276 2 3.07994 0.282626 9.06556 -18.5101 7.20519 -0.527908 -277 1 7.37599 17.2741 4.45241 45.8101 34.7343 -2.7797 -278 2 8.02493 17.9603 4.76808 -26.0663 -25.3607 -1.65849 -279 2 7.47725 17.3636 3.49301 -12.8678 -9.31687 6.18264 -280 1 9.20909 17.0315 12.2197 44.1268 -5.71549 17.0535 -281 2 9.48765 16.172 11.8421 -16.3435 15.6721 -2.29993 -282 2 9.99892 17.2887 12.7762 -25.7988 -5.61825 -13.0657 -283 1 13.3284 13.0292 7.94175 -52.6762 -33.6944 -6.73328 -284 2 13.0533 12.253 8.47808 14.3801 9.17086 -2.06391 -285 2 14.1985 13.2855 8.14946 32.3912 12.3835 13.183 -286 1 14.9871 2.94126 15.3478 14.7752 10.8142 -9.8874 -287 2 14.2243 2.52816 14.9303 6.27209 -7.10728 -1.53608 -288 2 15.7054 3.02501 14.6718 -21.9622 -5.02255 13.6584 -289 1 9.85637 15.4939 17.0026 6.25802 5.34328 -5.30261 -290 2 10.2013 14.6312 16.7411 3.93948 4.67059 -1.18803 -291 2 9.35728 15.3668 17.8085 -8.94372 -2.90673 5.88613 -292 1 11.2848 8.23994 16.5492 3.15289 33.2939 2.2253 -293 2 10.8315 7.75123 15.8747 -9.91387 -14.5897 -7.3255 -294 2 11.7506 7.62533 17.1016 4.32393 -13.5731 6.91104 -295 1 3.77097 18.1898 16.7118 5.96936 32.6304 11.943 -296 2 4.24576 17.6768 17.3569 8.77088 -19.0197 5.38959 -297 2 3.7978 0.441972 17.1008 -3.8528 -14.6362 -12.0582 -298 1 2.20581 4.09889 8.95874 4.57905 1.19328 9.26631 -299 2 3.00197 3.55544 8.74643 -17.2537 17.4622 14.7611 -300 2 2.10364 4.24367 9.94001 11.4926 -15.28 -28.3391 -301 1 9.9196 10.3581 9.75231 -27.966 16.15 -17.0738 -302 2 9.34403 11.1055 9.40387 24.0849 -21.7639 18.0289 -303 2 9.87032 10.282 10.7171 1.16507 9.52838 -7.01624 -304 1 9.73405 0.807167 10.8572 18.2139 21.6835 4.91261 -305 2 9.58177 18.5811 11.2204 -14.9491 -12.8069 -2.84973 -306 2 9.10878 1.03014 10.1675 -9.37034 -6.01821 -3.77915 -307 1 9.18221 15.2247 10.2123 -19.1642 -10.2407 -19.6365 -308 2 9.04674 16.0847 9.7631 0.663926 -17.4388 12.4081 -309 2 8.3908 14.6843 9.94105 22.9839 14.6501 17.4764 -310 1 1.00316 9.27987 10.329 14.3691 -27.2472 -11.0896 -311 2 1.16727 10.1904 10.5724 12.779 8.1681 -2.56256 -312 2 1.84996 8.76119 10.1498 -30.7163 35.51 10.5854 -313 1 16.8004 4.89338 8.19813 23.5039 -12.6505 29.7165 -314 2 16.1748 5.31624 8.83318 15.8467 -9.35353 -17.5774 -315 2 17.4877 4.38941 8.71628 -29.2517 16.802 -13.3541 -316 1 14.6379 14.6893 0.402347 -11.159 -0.978579 14.7724 -317 2 14.9609 15.3376 1.05877 0.0769081 -12.0935 -6.53519 -318 2 13.9048 14.1906 0.841144 15.9383 15.9909 -14.4014 -319 1 3.51181 11.0525 9.63829 2.1739 12.5105 -11.7746 -320 2 3.41507 11.3617 10.5484 4.86707 2.92948 -3.5212 -321 2 3.25155 11.8076 9.06383 -0.0479228 -15.275 7.06779 -322 1 11.0289 10.8695 1.26208 17.169 21.0662 -6.34954 -323 2 11.1535 11.716 0.753779 -4.03889 -27.9068 14.1765 -324 2 10.1142 10.5923 1.16471 -3.02205 2.54599 -1.38039 -325 1 13.2239 7.06188 12.8977 -30.3793 3.52384 -4.06516 -326 2 14.1381 6.84046 12.8922 25.6531 -5.59605 1.27225 -327 2 12.7471 6.22139 12.9668 3.13335 6.34025 -4.15647 -328 1 9.62584 1.88878 0.937813 20.0839 -1.09549 37.2578 -329 2 8.77484 2.11506 0.623903 -26.2152 1.3675 -15.013 -330 2 10.1764 1.70882 0.191067 9.10224 -0.512606 -16.4895 -331 1 10.6054 13.537 4.7508 -3.45661 -5.20977 -1.23778 -332 2 11.3208 12.9359 5.04367 -5.78837 16.6981 -6.98771 -333 2 10.4128 14.1619 5.47507 11.2154 -13.4565 -5.70688 -334 1 14.2525 1.6915 10.8868 25.1006 21.2848 4.13062 -335 2 15.0842 1.26497 10.6465 -4.75627 -8.22365 -3.1417 -336 2 14.5069 2.62992 10.8824 -13.5101 -4.08816 2.36647 -337 1 14.6678 12.4248 11.7157 -12.7858 -12.3306 -9.5252 -338 2 15.5574 12.5766 11.3177 -24.032 -11.5318 -4.29299 -339 2 14.0022 11.9667 11.1187 32.4402 16.632 10.9337 -340 1 8.24065 5.08218 9.78509 -7.81525 41.6802 29.5679 -341 2 7.45364 5.10173 10.3836 16.236 -11.1581 -20.3292 -342 2 8.36822 4.22882 9.41503 -10.4798 -31.0118 -7.50393 -343 1 1.59893 16.8132 18.3262 1.78713 43.6046 -19.4726 -344 2 1.99225 17.1675 17.4932 -13.4068 -2.95443 18.1753 -345 2 1.72693 15.8931 18.2458 9.12037 -33.6792 3.80865 -346 1 1.43382 17.2563 15.3383 70.3372 -10.1908 -13.5082 -347 2 1.32309 18.1562 15.5759 -5.39176 26.6374 11.2222 -348 2 0.623143 16.841 15.3782 -64.6751 -20.2725 0.847241 -349 1 3.73599 5.55499 6.2196 -13.8181 39.8005 -2.84681 -350 2 3.32092 6.26594 6.76194 2.21889 -20.7758 -8.723 -351 2 4.19567 6.05321 5.52665 5.67395 -4.434 2.61268 -352 1 12.357 9.41487 14.1826 15.3987 -29.3966 1.09302 -353 2 12.9591 8.63784 13.9021 -33.8501 34.209 16.2235 -354 2 11.936 9.15457 15.0346 16.6427 1.77305 -15.4117 -355 1 4.0362 15.2647 6.90572 33.8672 24.728 -7.08093 -356 2 3.45744 16.0249 6.7945 -6.17655 -1.99751 -5.28974 -357 2 4.92941 15.6518 6.66696 -29.006 -22.9584 9.78444 -358 1 0.606517 8.56128 14.8606 9.39684 15.8059 -8.30397 -359 2 0.498099 9.52604 14.9437 -1.87135 -9.61679 5.58044 -360 2 1.28855 8.50016 14.167 -9.83185 -6.21013 7.33103 -361 1 12.9763 8.3683 10.3434 1.19405 4.03237 -29.9304 -362 2 13.7163 7.90436 9.89822 -7.22584 1.47622 17.5396 -363 2 12.9003 8.0957 11.2534 8.23718 -11.529 10.7869 -364 1 15.2983 7.63672 3.47583 -36.323 -26.5913 31.5529 -365 2 14.5024 7.10501 3.29647 15.7237 15.5958 -25.1442 -366 2 15.2922 7.47095 4.43335 26.8259 14.207 -3.84044 -367 1 17.3208 6.63818 0.028906 -16.9884 17.5938 -6.80353 -368 2 16.7479 6.05403 0.554933 4.15554 3.30118 -7.73843 -369 2 16.7141 7.27151 18.2009 11.1968 -20.2911 18.275 -370 1 8.79355 6.92545 7.84172 -17.9944 -26.8715 17.7017 -371 2 9.63968 7.32585 7.85068 34.0918 14.4557 -5.0304 -372 2 8.77688 6.39871 8.67404 -5.99252 8.25367 -18.4431 -373 1 12.3209 0.607808 1.1741 -9.70621 -1.67076 -6.18378 -374 2 12.995 1.15082 1.58835 11.8921 -6.95349 3.94176 -375 2 12.79 18.5825 0.66073 -1.23695 5.23567 5.50046 -376 1 5.68514 15.097 14.5145 3.67475 30.0662 -16.0184 -377 2 4.72797 15.1695 14.4772 -3.92865 -1.97247 7.85561 -378 2 6.02476 15.8935 14.032 -4.97132 -21.5573 17.6103 -379 1 3.822 6.53853 1.67803 9.4136 -3.73603 -11.0507 -380 2 3.54968 7.33117 1.17576 -2.2757 -10.4776 17.1213 -381 2 3.81642 6.7886 2.60252 -0.785086 8.11893 4.5328 -382 1 3.89262 11.6088 12.227 13.3033 3.31132 5.82178 -383 2 4.72051 12.1032 12.348 -1.72331 -9.21471 -1.78635 -384 2 3.26281 12.0921 12.7526 -14.3078 7.33513 5.3451 -385 1 5.45444 3.88172 15.8755 10.9934 63.7886 22.8921 -386 2 5.90627 3.24049 15.3708 25.1493 -29.4334 -15.1609 -387 2 6.11665 4.65725 15.9739 -37.1513 -37.4972 -5.17498 -388 1 14.4636 10.317 4.39501 8.04256 -17.7362 -43.5508 -389 2 14.9051 9.88853 5.13417 -2.05112 -4.59794 0.583625 -390 2 14.7084 9.81768 3.53446 -13.0506 20.827 46.8358 -391 1 7.94949 17.2895 9.24469 -12.4073 10.6503 -4.49958 -392 2 7.23447 17.5423 9.86969 11.4984 0.663317 -18.2334 -393 2 8.01085 17.8889 8.47627 -8.74254 0.310971 13.2931 -394 1 4.4986 14.4237 3.96317 22.7921 6.59984 27.2073 -395 2 4.89523 15.3318 4.14709 -15.7294 -33.8816 -1.82578 -396 2 4.80237 13.7713 4.67129 -10.4496 32.1184 -24.135 -397 1 14.3358 7.38467 15.7635 24.4704 6.70756 7.84838 -398 2 15.2401 7.23754 15.391 -26.2451 3.74497 13.7384 -399 2 14.4998 7.83446 16.6232 -7.00308 -11.7114 -18.5693 -400 1 2.86875 18.2246 1.90934 8.22952 29.9251 46.5059 -401 2 2.54447 17.7626 1.17928 -17.7355 -34.6574 -39.0362 -402 2 2.08284 18.4154 2.45796 15.223 4.61378 -9.70941 -403 1 7.96139 1.61197 4.52525 29.4796 -3.5692 28.5612 -404 2 7.4985 1.83317 3.72811 -4.47294 12.8461 -13.1797 -405 2 8.84188 2.051 4.57628 -23.8244 -8.06079 -10.6756 -406 1 2.69247 14.1251 17.7583 -39.7925 -12.5472 14.0506 -407 2 1.78944 13.8074 18.0556 30.3506 3.26472 -13.0537 -408 2 3.33089 13.517 18.1683 -2.67461 8.7222 -7.81087 -409 1 0.711797 1.68055 13.8626 44.8563 0.102291 -15.8697 -410 2 0.854596 1.56791 14.7929 -2.34617 -4.64243 17.7358 -411 2 18.4557 1.86826 13.7064 -36.5874 5.33291 1.35002 -412 1 4.5582 18.5986 13.9691 17.69 -10.1212 -17.3986 -413 2 5.37614 18.0918 13.7297 -17.5363 18.7277 11.6893 -414 2 4.4096 18.4453 14.9034 -4.80692 -4.44744 5.40837 -415 1 7.10973 0.453475 18.3742 -17.6731 43.6393 33.9394 -416 2 6.99644 0.098599 17.5235 3.55611 -15.5456 -38.0778 -417 2 6.34312 1.05085 18.5323 11.5496 -19.3687 -0.295067 -418 1 16.0934 18.4421 14.1505 -13.5696 -24.3411 -34.6818 -419 2 15.444 17.7866 13.7542 20.5302 26.3107 23.9987 -420 2 16.0379 18.4915 15.109 -11.2087 -0.403296 -0.42938 -421 1 10.1156 4.52417 16.2956 -63.5341 -10.6596 -28.1335 -422 2 10.9808 4.34247 16.5381 54.6034 1.03427 17.4186 -423 2 9.84863 3.69679 15.8473 1.5569 12.8802 9.55133 -424 1 15.8226 17.9425 4.41327 -12.7412 7.89699 33.5898 -425 2 16.5547 18.5732 4.53052 -9.15632 -3.64108 -2.38506 -426 2 15.1071 18.2295 5.06915 28.1993 -15.1976 -35.9746 -427 1 6.9246 17.3574 13.7412 41.9162 15.5861 -1.52717 -428 2 7.49648 17.8115 14.4369 -23.1807 -22.4309 -23.3681 -429 2 7.52703 17.1963 12.9658 -13.588 5.84324 25.6525 -430 1 13.2892 6.57209 6.73437 -45.0771 -7.84691 9.23056 -431 2 14.2146 6.66317 6.83486 35.9508 1.69852 -11.4068 -432 2 13.0394 6.38579 5.82242 8.43649 1.47489 -3.25235 -433 1 7.6616 2.3861 9.17526 8.07841 -8.24756 -37.8228 -434 2 7.32169 2.39592 10.0555 -17.554 -3.79201 20.6206 -435 2 6.95914 2.1022 8.53308 18.9972 7.96045 22.8376 -436 1 15.1464 14.8771 13.6482 -9.08859 5.19149 1.30171 -437 2 15.0308 15.0223 14.6069 -2.64384 -0.244686 -12.5428 -438 2 14.3194 15.1152 13.1798 15.9342 -4.32482 12.4068 -439 1 9.29105 8.34315 3.70472 25.3147 -22.6228 7.1656 -440 2 10.1776 8.75859 3.73678 -14.6049 0.788849 -0.227964 -441 2 9.48378 7.39942 3.88081 -7.38963 16.6026 -2.51653 -442 1 17.6854 13.4687 16.4528 1.20699 34.422 -16.619 -443 2 16.7357 13.4337 16.3398 -3.15338 -8.61752 5.60033 -444 2 17.8844 14.3284 16.0065 4.30498 -21.0483 11.9174 -445 1 5.04883 10.6547 2.58751 21.171 -14.0773 3.70172 -446 2 5.87017 10.3468 3.04382 -23.0848 5.17759 -4.78185 -447 2 4.55197 11.1441 3.22928 -5.68041 9.33128 13.9497 -448 1 3.70566 8.3683 10.3381 2.8322 -31.099 -4.13864 -449 2 3.86061 9.29726 10.2176 3.71195 18.7597 0.626964 -450 2 3.86652 8.14601 11.2715 -4.70232 11.1023 -9.34814 -451 1 16.1079 7.11641 6.33859 19.1617 -15.4194 -14.8444 -452 2 16.7241 7.70559 6.80408 -7.69122 -6.37409 -7.38138 -453 2 16.6678 6.33083 6.12136 -24.1396 12.8226 8.63966 -454 1 15.2027 7.00502 9.1117 -12.4455 33.5656 -30.1004 -455 2 16.009 7.42176 9.46585 -11.7729 -5.93044 -7.51071 -456 2 14.9881 7.51375 8.25647 14.3105 -22.443 40.0586 -457 1 6.4525 13.1649 12.9201 -14.4212 4.62434 6.2224 -458 2 7.2977 12.7289 13.0561 -0.519457 -3.7562 7.19322 -459 2 6.25327 13.7237 13.7059 9.03992 -10.4089 -22.4145 -460 1 12.1145 4.49786 13.0694 60.1541 40.3897 -0.599702 -461 2 12.3852 4.68406 13.9868 -12.8154 -8.572 -1.53547 -462 2 11.3952 3.9317 13.0199 -51.9002 -33.7145 4.15206 -463 1 11.3323 8.18365 7.8522 33.2694 0.481688 12.7059 -464 2 12.0901 7.73501 7.43634 -16.2057 -1.97452 -6.97761 -465 2 11.7651 8.45102 8.68662 -20.5523 -0.0583287 -5.01537 -466 1 17.1666 10.776 7.42179 36.6255 -17.1838 -28.5238 -467 2 17.7906 10.0723 7.08441 -19.5131 16.2155 23.227 -468 2 17.2793 11.4524 6.73733 -13.1225 1.2547 8.82205 -469 1 5.22802 18.1471 11.05 -26.218 -15.3265 2.15414 -470 2 4.73762 18.1049 11.901 9.27461 0.443739 -18.2338 -471 2 4.62535 17.7417 10.374 18.9971 14.5949 15.121 -472 1 7.56653 17.6363 1.80821 2.05543 -3.48119 51.3305 -473 2 7.65741 16.7768 1.42856 8.63412 -18.3953 -16.9352 -474 2 7.35855 18.2549 1.13994 -1.30452 14.3677 -27.7338 -475 1 1.85092 12.9256 13.6076 17.4877 19.0754 23.2488 -476 2 1.72104 12.4156 14.4258 -6.17153 0.259213 -13.4945 -477 2 2.19932 13.7866 13.9501 -9.51965 -23.6336 -9.57422 -478 1 9.73868 6.79159 14.8001 -20.4051 42.5069 -0.796717 -479 2 9.95236 5.95211 15.1529 11.7083 -38.3225 9.01974 -480 2 9.967 6.84408 13.8723 6.06139 -4.97285 -7.43337 -481 1 15.2087 4.3972 10.7794 -26.9028 -24.0998 -25.0358 -482 2 16.0082 3.89203 10.8637 24.0661 5.32644 6.50358 -483 2 15.2102 5.16148 11.3322 8.70888 13.5856 17.3899 -484 1 11.1963 6.12482 0.150068 -24.122 -22.6006 13.7234 -485 2 11.2381 5.20796 0.481504 11.6671 13.7026 -10.2768 -486 2 10.2374 6.21547 18.6186 16.3103 12.5014 -3.12394 -487 1 0.19533 11.3359 15.1413 -21.6592 10.769 -30.7731 -488 2 18.4021 11.874 14.3993 14.4722 -20.1415 31.2795 -489 2 18.4481 11.661 15.9631 4.68348 9.49999 -5.94609 -490 1 7.06882 9.13032 7.26059 -22.6631 -3.09615 15.424 -491 2 6.55985 8.40099 7.69941 15.0645 18.9564 -17.5163 -492 2 7.9725 8.82922 7.21375 6.85038 -6.33336 0.902711 -493 1 18.4578 15.4507 12.3537 6.97015 0.808933 -7.22971 -494 2 0.776651 15.5698 12.2511 -16.5258 -3.56518 7.28193 -495 2 18.1456 15.6789 11.4721 -4.11121 -1.28038 2.68538 -496 1 16.5694 4.36967 5.25107 2.45626 -29.8761 41.2812 -497 2 16.7744 3.81151 6.06026 -19.4928 29.4804 -23.4548 -498 2 17.3898 4.32671 4.78168 14.6436 6.44337 -19.6343 -499 1 17.788 3.06911 10.7078 8.19486 16.3181 17.0759 -500 2 0.075758 3.1322 11.0257 -18.3141 -4.46618 -10.1687 -501 2 17.6332 2.20749 10.3226 7.04824 -10.7221 -5.22745 -502 1 12.3142 0.064083 10.1758 -16.6046 52.5698 5.40656 -503 2 11.3746 0.384648 10.259 27.2889 -19.3162 -0.832384 -504 2 12.8178 0.919304 10.3228 -10.5773 -40.3011 -9.47381 -505 1 10.3666 9.83315 12.2981 15.5663 4.35939 24.9446 -506 2 11.1015 9.85063 12.955 -12.9587 3.49885 -14.3711 -507 2 10.1328 8.91188 12.2898 -2.48305 -14.5784 -4.85859 -508 1 0.463654 2.82678 7.01839 21.5285 29.229 11.0876 -509 2 0.875324 3.58845 7.48211 -15.1018 -9.47019 -10.8481 -510 2 0.770257 2.12665 7.58365 -2.10845 -18.3887 2.87796 -511 1 0.478371 15.2358 6.91004 -5.05906 -57.415 8.40739 -512 2 0.585298 15.6463 7.75647 1.85019 10.3725 13.8373 -513 2 0.556531 14.2524 7.18353 -2.63305 52.383 -27.2731 -514 1 16.9534 7.00251 15.3394 -15.9191 6.08615 -6.45156 -515 2 17.6338 7.63543 15.0899 14.1822 -6.8729 3.83609 -516 2 17.3093 6.19568 15.7235 10.8839 2.85836 -7.52482 -517 1 9.0001 12.4151 8.13768 -31.1102 30.9609 25.8163 -518 2 9.37386 11.8218 7.49742 -5.17233 -14.4246 -22.3971 -519 2 8.02402 12.632 8.03373 38.2843 -19.0142 -6.47162 -520 1 1.27238 1.95406 3.05803 -13.5483 -7.94682 -18.4152 -521 2 1.26084 2.61511 2.34121 0.274888 -9.5029 12.9388 -522 2 1.89031 2.22344 3.73293 6.76618 11.1556 -0.474465 -523 1 4.13907 15.1156 9.62039 -21.6353 8.89781 12.928 -524 2 4.07003 15.1439 8.65747 6.73796 -2.17255 1.87071 -525 2 4.96029 14.7006 9.86457 13.8731 -5.89958 -3.36363 -526 1 7.17628 2.17866 14.5671 10.1969 15.6665 0.500505 -527 2 6.99528 1.68402 13.7698 -5.58163 -4.27811 -6.1139 -528 2 7.62131 2.98432 14.249 -3.31044 -9.5634 8.35677 -529 1 18.6082 14.7131 2.1481 32.6395 -16.0207 -3.46113 -530 2 0.838003 15.1297 2.25966 -5.15041 -8.02703 -3.38947 -531 2 17.988 15.3544 2.42675 -27.9684 22.1971 4.74449 -532 1 9.94138 2.79524 12.9422 16.7157 -19.9527 -5.96647 -533 2 9.79404 2.1456 12.2228 -2.63367 12.9584 8.66897 -534 2 9.17835 3.36299 13.0326 -7.96092 5.51528 -6.54514 -535 1 2.80444 8.90955 13.0076 -17.7822 -13.1167 0.317539 -536 2 3.06361 9.80599 12.872 10.5962 22.9278 -4.25378 -537 2 3.5122 8.48618 13.4775 15.1932 -9.60442 7.00981 -538 1 3.236 8.3574 3.63664 -2.86765 -22.2709 68.2353 -539 2 3.45085 9.0718 3.07326 14.564 28.9211 -13.7717 -540 2 3.47645 8.58669 4.60794 -11.4307 -4.68562 -51.1711 -541 1 5.62853 7.18594 8.51094 8.63755 21.4894 2.16978 -542 2 5.46784 6.31815 8.13889 -3.95344 -9.53044 10.3317 -543 2 4.96415 7.47792 9.15047 -3.24726 -12.0183 -2.29801 -544 1 14.8757 1.26039 2.01768 8.95967 6.82752 -28.1452 -545 2 14.9353 2.01952 2.56559 -6.40438 15.8227 28.9683 -546 2 15.2784 1.60993 1.21235 -4.35761 -14.1118 -5.79377 -547 1 8.22892 15.2012 0.850139 10.8537 -12.6178 7.38979 -548 2 9.02213 14.9338 1.33488 2.38301 14.3333 -0.830013 -549 2 7.55366 14.6663 1.27665 -9.08858 2.03607 -6.2405 -550 1 15.6387 1.34587 7.23673 -38.2068 -12.1482 -8.38322 -551 2 14.9277 0.724731 6.91269 26.6184 17.4884 8.18161 -552 2 15.1173 2.1119 7.53894 10.4663 -3.86302 -4.52487 -553 1 4.90142 13.0959 18.5232 17.6249 -4.01801 23.9701 -554 2 5.32755 13.082 0.76977 -10.7656 0.632793 -19.6876 -555 2 5.44764 13.7122 18.0259 0.499955 -3.74815 -4.96885 -556 1 15.3368 8.46948 18.1479 21.2409 26.352 -19.7425 -557 2 15.8061 9.12264 17.5623 -15.5364 -21.5252 11.6976 -558 2 15.3318 8.91689 0.353875 -5.84476 0.442576 5.05054 -559 1 12.0708 3.01842 18.3809 -8.91332 38.2285 -17.9492 -560 2 11.9316 2.65996 0.60646 7.08072 -18.979 4.32412 -561 2 12.6022 2.47389 17.7995 4.78982 -18.1658 8.07002 -562 1 13.2139 12.6752 5.17768 -9.57044 10.0795 -9.57129 -563 2 13.7464 12.0348 4.69253 1.60656 -5.44915 8.62561 -564 2 13.2564 12.5123 6.11793 10.4898 -3.48459 7.66387 -565 1 6.05443 7.0356 0.031519 0.0605761 -19.9038 6.17744 -566 2 5.93935 7.95118 18.5019 3.71712 34.2187 -1.98634 -567 2 5.39095 6.86665 0.702638 -7.83388 -10.1683 0.476271 -568 1 17.7528 16.0276 15.0213 -25.9758 6.2762 6.79882 -569 2 16.9476 16.5457 15.105 3.54626 -1.67183 20.5845 -570 2 17.7479 16.0055 14.0813 22.8568 -13.146 -30.1028 -571 1 13.196 0.994907 16.5363 6.37162 1.07879 13.9702 -572 2 14.1481 0.997912 16.7614 -14.4757 -4.73392 -6.84542 -573 2 12.8833 0.094199 16.7238 3.07394 5.84273 -8.05351 -574 1 11.1253 14.5647 7.20271 13.6513 20.7581 -19.5035 -575 2 10.4007 14.3183 7.72981 -32.979 -9.13798 24.3252 -576 2 11.7186 13.8255 7.26943 15.8912 -3.80541 2.99114 -577 1 17.5081 8.62849 2.08107 17.5857 37.593 18.6886 -578 2 16.6801 8.63471 2.55495 -11.5266 -11.0229 1.73392 -579 2 17.5233 7.88242 1.516 -4.85302 -28.502 -20.2632 -580 1 12.3547 8.01168 2.02213 2.8693 7.47745 -2.1033 -581 2 12.2384 8.8582 1.54611 -1.5199 -14.1485 9.25757 -582 2 11.9739 7.3152 1.48261 -4.60849 0.564674 -12.802 -583 1 11.8761 14.6165 10.3364 -1.28632 -27.1744 -11.0444 -584 2 12.1004 13.7873 9.81464 -15.5434 34.4502 21.6186 -585 2 10.8993 14.6888 10.473 22.8986 -6.0814 -12.7032 -586 1 6.89524 7.05211 15.6117 2.70483 5.93472 10.8866 -587 2 7.81004 7.26536 15.3122 -19.1207 -0.823892 9.8847 -588 2 6.66676 7.54167 16.4408 15.3743 -10.0989 -25.4065 -589 1 8.00326 4.73593 13.4743 46.2088 18.1039 21.0673 -590 2 7.23337 4.7302 12.9572 -37.1051 2.19442 -26.1447 -591 2 8.40671 5.62958 13.343 -9.63909 -26.9075 5.20654 -592 1 13.4128 12.1818 14.2522 -5.46405 -2.8504 7.05596 -593 2 12.9414 11.3292 14.2657 10.1901 3.29349 -5.65079 -594 2 13.7875 12.315 13.3696 -1.58979 -2.51674 3.72795 -595 1 14.8395 9.42189 7.30548 -10.1492 -33.0314 -14.9507 -596 2 15.7087 9.765 7.42505 18.3001 17.1245 4.25051 -597 2 14.2269 10.0768 7.57319 -16.3703 19.68 11.0075 -598 1 12.6526 17.0686 3.07252 -25.5483 38.6692 13.4046 -599 2 12.8376 17.5237 3.93373 3.7914 -19.7635 -24.6942 -600 2 11.9913 17.6958 2.63477 29.3498 -30.5169 14.5322 -601 1 1.15545 7.13838 17.4647 -1.30818 10.8795 -24.4228 -602 2 0.330359 7.36323 17.9184 3.51096 -10.352 -1.0007 -603 2 1.05514 7.47868 16.5422 2.6229 -4.15873 21.1004 -604 1 12.7562 5.15096 15.6457 46.9745 -3.15458 16.4241 -605 2 13.4512 4.55662 16.0315 -23.8856 11.8204 -16.5269 -606 2 13.2414 6.00335 15.5788 -13.869 -10.6853 0.37407 -607 1 2.53993 3.38757 4.97618 -24.4059 44.0626 48.9955 -608 2 1.7609 3.18232 5.58922 29.5313 1.39757 -24.0522 -609 2 2.84154 4.31546 5.27885 -6.94106 -48.8689 -12.2378 -610 1 8.33186 11.2983 13.4548 -25.447 4.99647 44.923 -611 2 8.4244 11.0562 14.4444 7.04045 1.38295 -54.395 -612 2 8.91168 10.8786 12.8197 20.7237 -12.5345 14.2107 -613 1 12.8689 1.31514 13.3384 4.70567 59.9078 -15.5432 -614 2 13.42 1.58034 12.5659 -9.46235 -19.1343 13.2352 -615 2 12.4231 2.17844 13.5496 8.70338 -32.6779 -3.58081 -616 1 6.34008 13.7169 2.14963 -19.3306 -6.11379 22.757 -617 2 5.63978 13.877 2.82959 17.9638 4.85668 -21.8758 -618 2 6.88351 13.0442 2.56282 8.57629 -2.48731 -1.94932 -619 1 15.9206 6.61444 12.7992 -23.3103 -26.3741 2.68057 -620 2 16.3106 7.25195 12.2393 16.9755 20.6681 -18.7226 -621 2 16.4213 6.59661 13.608 7.79648 1.05266 12.4236 -622 1 16.8298 0.712824 9.59482 4.79811 -22.8344 -3.47194 -623 2 16.8791 18.3713 9.72616 -6.98639 26.8255 -1.99774 -624 2 16.5452 0.8605 8.67269 -2.39382 -2.67689 10.2173 -625 1 6.14624 11.7631 8.37671 0.189841 -56.9827 6.97012 -626 2 5.32447 11.4591 8.84151 16.7156 13.8425 -13.046 -627 2 6.64226 10.8931 8.20176 -19.0535 39.3101 2.14415 -628 1 2.88754 8.61261 0.453821 12.2401 -11.553 -23.675 -629 2 2.45212 8.04764 18.3917 -4.84247 31.247 26.7064 -630 2 2.34875 9.28564 0.895642 -13.4946 -8.81401 -13.4914 -631 1 10.1674 10.4623 6.50123 4.87464 -2.88608 -13.8248 -632 2 10.6087 9.69731 6.89122 -0.620763 2.00125 4.93232 -633 2 10.4694 10.4636 5.56932 -5.34739 2.02001 15.3519 -634 1 6.7142 15.6951 6.55167 22.995 7.84961 12.6004 -635 2 7.14328 16.1838 7.27089 -9.73558 -8.55589 0.364412 -636 2 7.21237 16.006 5.79102 -10.9792 5.43097 -10.3878 -637 1 6.445 13.1807 5.57797 -3.32019 -20.8794 2.06608 -638 2 6.7301 13.9465 6.07331 -1.80129 7.88671 5.96843 -639 2 6.09943 12.5433 6.22286 1.13913 6.90777 -2.85329 -640 1 16.8242 12.5629 9.83758 3.36613 -21.9924 0.476486 -641 2 16.9985 11.8651 9.16533 -5.29916 18.5903 6.02329 -642 2 16.5644 13.3844 9.42716 1.61266 3.35571 -10.8679 -643 1 6.03738 2.95058 2.86354 -7.51536 -24.4327 -2.00067 -644 2 6.40977 3.757 2.57075 14.9417 32.1903 -3.64532 -645 2 5.57703 2.61747 2.09059 -4.23441 -8.07329 -3.19257 -646 1 10.9114 3.33767 3.30112 3.4906 -2.16377 5.30702 -647 2 10.297 4.02722 3.58926 -1.61521 -6.66566 -5.52383 -648 2 10.5127 2.84524 2.57795 -5.77666 1.81375 -3.43243 -ITEM: TIMESTEP -10 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.68194 7.08301 17.95 -9.31723 -4.61569 5.17534 -2 2 7.78696 6.81626 18.2438 14.604 4.05464 -8.83536 -3 2 8.80373 6.759 17.0506 -2.23465 -3.10488 4.80291 -4 1 18.5422 8.2512 6.84005 -1.85374 20.2636 49.1182 -5 2 0.133718 7.9438 5.98823 13.4692 -17.0673 -32.1853 -6 2 0.402402 7.78616 7.5434 -4.29735 0.835788 -17.7519 -7 1 8.38516 18.5522 6.81414 18.1861 9.65042 -3.37417 -8 2 9.3349 0.126592 6.72298 -16.1755 -3.42506 1.43069 -9 2 7.92248 0.594936 6.31239 0.819355 -0.881225 3.09059 -10 1 6.59178 1.84314 11.71 32.0023 -4.98621 -11.2566 -11 2 5.89352 2.36713 12.0513 -24.1224 14.8358 13.0259 -12 2 6.19214 1.0378 11.3953 -8.69892 -12.638 -2.90229 -13 1 7.13386 5.75674 2.33026 -14.5408 0.616599 17.9391 -14 2 6.48306 6.1089 3.01881 22.5383 -2.3727 -34.6055 -15 2 7.09544 6.2305 1.47237 -10.8297 -1.47351 21.389 -16 1 16.2171 10.1491 16.1328 -28.1801 3.24526 14.6911 -17 2 17.0032 10.2274 15.6211 19.8027 8.68317 -10.1896 -18 2 15.8342 11.0337 16.2804 9.6716 -6.93987 -4.62354 -19 1 10.6069 15.0266 2.30703 -4.98248 -17.7421 -7.27467 -20 2 10.5595 14.4209 3.0573 0.524935 2.03122 3.93242 -21 2 11.0455 15.8043 2.63229 7.74565 12.2645 5.86516 -22 1 17.1614 8.24714 10.3877 8.07926 1.42828 6.48104 -23 2 16.5623 8.78009 10.9215 0.0316367 4.64377 2.31684 -24 2 17.9785 8.76022 10.2824 -6.97801 -4.40732 0.702868 -25 1 14.8935 15.8724 16.3278 20.2214 -7.01151 6.5945 -26 2 14.0152 16.2142 16.2283 -22.9266 5.478 3.03945 -27 2 14.9126 15.3591 17.1528 -4.85523 2.97165 -4.07838 -28 1 12.1655 13.3835 0.413391 7.36911 -14.3954 12.824 -29 2 12.1103 13.7323 18.1651 -6.85057 6.78658 -3.29346 -30 2 11.6807 13.9152 1.05851 -4.03153 8.23708 -7.75902 -31 1 9.27599 5.36662 4.05276 -29.4571 7.127 11.0843 -32 2 8.67176 5.26931 4.85064 22.4619 1.60875 -30.6294 -33 2 8.67539 5.53054 3.28716 9.26602 -4.36827 15.8404 -34 1 1.82909 4.27439 11.6483 -10.3032 26.7578 -2.81239 -35 2 1.73625 5.21877 11.9337 1.99226 -22.9368 -8.90994 -36 2 2.3645 3.83767 12.2983 6.89168 -8.93952 11.7704 -37 1 1.96701 6.83625 8.36791 0.700563 -10.6105 -3.76521 -38 2 2.46094 7.16371 9.10974 5.61647 13.7513 9.96296 -39 2 1.91553 5.8986 8.57777 -2.9792 -4.95164 -6.48224 -40 1 5.40472 4.39468 7.93775 -13.5219 -10.4794 -16.6571 -41 2 5.47247 3.43369 7.82443 4.19114 6.69916 9.09153 -42 2 4.75726 4.62849 7.24994 8.09624 5.59982 9.8174 -43 1 3.2394 2.92305 17.5474 -0.484589 33.1528 15.1222 -44 2 3.93082 3.31406 16.9898 -0.722116 -4.79924 0.441987 -45 2 2.93778 3.68549 18.1255 3.8058 -28.2307 -17.5498 -46 1 7.46921 5.27133 6.11017 -1.04832 -15.5011 48.3459 -47 2 7.90561 5.59719 6.92877 -0.90713 11.0324 -30.0179 -48 2 6.96076 4.54233 6.5205 0.0145083 12.7024 -20.8234 -49 1 9.7753 7.02229 11.9825 10.38 0.905424 28.7819 -50 2 10.3185 6.36588 11.5577 3.53671 -5.58238 -7.94156 -51 2 9.14507 7.32646 11.347 -14.6838 3.32198 -19.6076 -52 1 14.1071 3.54759 8.03608 -23.8038 4.02857 -21.7378 -53 2 13.5341 4.25359 7.68722 9.9361 -9.73972 0.838395 -54 2 14.4214 3.88758 8.85457 11.6 9.53944 21.926 -55 1 4.79933 17.2591 4.02624 -13.379 0.496236 -8.73431 -56 2 5.57386 17.851 4.10922 -16.5825 -9.69995 -7.24814 -57 2 4.20396 17.5018 3.27728 17.9024 3.63898 12.5287 -58 1 16.5033 16.6227 10.0525 8.55043 -2.52252 -17.4646 -59 2 16.0579 16.4137 10.8501 -12.2091 1.77219 28.6058 -60 2 15.9447 16.1927 9.39741 3.82195 1.69594 -5.2917 -61 1 1.95551 4.92482 0.485806 10.2127 4.96395 -0.662752 -62 2 2.54163 5.27617 1.19707 -10.7364 -3.48306 -18.9921 -63 2 1.87778 5.63364 18.4632 -0.0680824 -4.88148 10.5435 -64 1 11.8064 13.3616 16.2803 -11.2011 -32.854 -16.2783 -65 2 11.3068 12.5375 16.4476 0.201944 14.5536 10.5803 -66 2 12.2047 13.1237 15.424 4.38621 16.2025 8.43328 -67 1 10.1065 11.0626 16.9483 14.8798 -23.3813 0.89342 -68 2 10.5718 10.2022 17.1278 -15.1514 23.106 -6.44625 -69 2 9.22125 10.8281 16.6474 0.614925 -0.65596 2.44857 -70 1 11.7253 17.5378 13.4688 -9.94093 -22.0621 2.41868 -71 2 12.2582 16.9669 12.8891 0.443382 11.1567 2.15207 -72 2 12.0419 18.4322 13.3705 7.56806 8.72697 -4.32807 -73 1 6.34321 9.31538 12.2256 -11.115 -24.1278 -16.4431 -74 2 6.95505 8.9709 11.5438 -2.74015 10.4344 10.5225 -75 2 6.7633 9.99127 12.7388 17.4243 13.1424 4.46627 -76 1 16.2194 12.7233 2.70094 -4.61478 -5.953 2.95318 -77 2 17.0002 13.1906 2.44934 22.4693 3.83429 -6.00104 -78 2 15.5655 13.415 2.69545 -17.2672 7.42791 2.42646 -79 1 0.634553 12.563 5.85853 -28.5577 11.9856 -12.6208 -80 2 0.914444 12.5082 4.92832 1.43228 -1.32003 11.8657 -81 2 18.3286 12.8558 5.76638 29.2028 -10.3468 5.65715 -82 1 5.19236 16.3841 18.4962 26.3246 -0.931967 -7.14386 -83 2 5.89246 15.8922 18.0344 -14.3156 -2.38899 -1.49205 -84 2 5.72254 16.912 0.454606 -10.9177 5.22319 5.94171 -85 1 0.515157 7.6307 4.06432 40.0561 19.3507 -22.9165 -86 2 18.554 8.04388 3.41083 11.6748 -7.97607 10.9949 -87 2 1.4672 7.83805 3.73432 -48.6916 -7.92141 18.8197 -88 1 3.14333 8.89821 6.52388 -38.7347 7.47588 -5.16066 -89 2 3.55606 8.61579 7.33755 0.264066 -1.79724 4.80444 -90 2 2.15121 8.92424 6.67318 38.4004 -3.38228 -2.38687 -91 1 7.3156 10.3041 16.1747 -22.5262 4.44621 22.8692 -92 2 6.53394 10.4783 15.6406 9.03524 -0.350523 -4.2891 -93 2 6.93671 10.3234 17.0875 14.5541 -1.9474 -13.7178 -94 1 11.1094 1.06061 5.00017 -8.33223 -1.63593 -20.1003 -95 2 11.1653 1.90766 4.53999 7.02718 4.91961 9.72987 -96 2 10.7116 0.517103 4.29895 3.46448 -7.62041 12.1963 -97 1 4.44086 2.70257 13.2121 -8.76198 -6.25056 -12.8305 -98 2 4.61839 3.20254 14.0253 0.411253 -15.6801 0.294236 -99 2 4.37598 1.71769 13.3483 2.92355 28.3656 12.0639 -100 1 8.41481 10.0299 1.78755 2.58083 -12.9704 20.4417 -101 2 8.40154 10.6596 2.53141 -0.930044 -1.16348 -6.83089 -102 2 8.61337 9.15635 2.20556 -3.35942 21.7495 -11.7521 -103 1 10.5245 1.75336 15.553 -8.62776 -1.95945 -5.61675 -104 2 11.4377 1.70086 15.8172 12.2485 -3.82632 7.39579 -105 2 10.5516 1.84495 14.595 -9.16331 1.82149 -1.12185 -106 1 2.77042 12.9421 7.75317 -7.76237 -6.33315 7.0975 -107 2 3.33238 13.5624 7.27685 -2.67968 -0.352894 -3.41328 -108 2 2.03777 12.7029 7.16368 7.79305 2.46945 -1.53229 -109 1 3.64399 11.6862 5.32015 -16.8384 -12.8234 -6.75612 -110 2 3.34983 11.0669 6.0167 8.99611 10.2661 -11.4747 -111 2 2.85416 11.8487 4.76712 13.6242 -0.0526402 5.20338 -112 1 6.87773 14.4784 16.8504 -8.96924 2.55968 -2.39612 -113 2 7.58262 13.8601 16.6681 3.90388 -1.06505 3.99858 -114 2 6.56163 14.7581 15.9821 -2.66358 -1.99085 3.97159 -115 1 14.1744 14.5416 3.41044 10.3942 -0.651763 -8.74467 -116 2 13.655 15.3132 3.20132 -4.79611 11.1016 -3.67227 -117 2 13.7666 14.1672 4.18264 -6.53868 -10.5118 9.50782 -118 1 8.26761 18.1769 16.0723 60.4333 -9.62543 6.95109 -119 2 8.90915 17.473 16.3173 -32.2452 -3.35667 -3.16806 -120 2 8.92378 0.250762 16.016 -23.6515 10.2222 -7.97846 -121 1 4.73314 1.61844 4.90498 10.4838 29.1168 -20.5116 -122 2 3.92346 2.13642 5.08344 11.5633 -7.75976 -5.77828 -123 2 5.26159 2.15735 4.23518 -22.3286 -21.1319 29.8735 -124 1 15.1246 12.8394 16.4387 17.4381 -4.51065 31.9511 -125 2 14.6778 12.9897 17.2989 -1.10989 -1.43715 -21.8055 -126 2 14.5277 12.6911 15.7205 -25.4533 -1.78625 -11.0751 -127 1 15.7863 18.3852 16.7922 25.908 13.3822 31.678 -128 2 16.4574 18.6243 17.5189 -32.4234 -15.7026 -31.1655 -129 2 15.6278 17.4293 16.8067 2.01305 5.51074 5.25351 -130 1 1.13886 1.13555 16.5514 1.07915 19.6556 20.6288 -131 2 1.93696 1.57732 16.8903 -4.88731 -5.90564 -11.4186 -132 2 0.480719 1.50241 17.171 6.36092 -10.7053 -11.3623 -133 1 18.0845 4.58532 15.87 11.914 -13.2929 -3.66508 -134 2 18.5793 3.94883 15.3177 -8.66069 11.808 8.70591 -135 2 18.5822 4.70936 16.6848 -0.518448 -1.56194 -3.55701 -136 1 12.2302 16.9486 16.128 -37.9176 -11.5423 26.3029 -137 2 11.3914 16.5899 16.5469 36.4287 7.40626 -6.62059 -138 2 11.916 17.193 15.2634 5.93841 3.5336 -18.1806 -139 1 15.8788 2.54988 17.9721 5.087 5.67773 0.124923 -140 2 15.7549 3.4391 18.3687 -1.45045 -15.8437 -11.8457 -141 2 15.6801 2.58174 17.0093 2.38633 7.36977 18.7833 -142 1 6.70786 13.8001 10.254 -2.60372 -2.62943 9.53833 -143 2 6.60649 13.5148 11.1732 2.18143 10.2669 -0.00882184 -144 2 6.57676 12.9909 9.76432 1.5038 -4.69959 -12.8892 -145 1 10.141 18.2121 2.80409 9.87418 27.4677 -18.8777 -146 2 10.2555 0.291999 2.14056 -0.137226 -16.5556 14.9505 -147 2 9.2689 17.8819 2.61553 -12.127 -4.1331 -0.131977 -148 1 2.97228 17.7542 6.06181 -6.28377 0.301135 37.0401 -149 2 2.07671 17.601 5.72694 10.6784 2.25774 -14.0772 -150 2 3.63482 17.801 5.37776 -0.270923 -2.52512 -18.6151 -151 1 12.5659 17.001 7.96656 -23.415 -18.3905 24.197 -152 2 11.9071 16.2804 7.97312 11.7411 4.46809 -11.7089 -153 2 12.3405 17.4671 8.78984 12.2149 7.72109 -10.0441 -154 1 14.887 15.2779 8.2893 -14.8827 1.47652 2.73183 -155 2 14.0296 15.7117 8.25541 -5.1427 0.792443 13.0916 -156 2 15.1979 15.4906 7.42354 24.2513 -3.00083 -20.068 -157 1 17.5454 18.3111 0.374663 -13.7707 -4.14946 -2.00055 -158 2 18.2555 17.754 0.11924 20.0055 -25.3354 -15.9225 -159 2 18.0059 0.295965 0.896687 2.592 26.2966 16.2474 -160 1 0.909555 10.373 1.4127 -25.0541 -38.6286 23.1399 -161 2 0.0989843 9.87796 1.71715 28.402 10.794 -7.01331 -162 2 0.540787 11.0804 0.922273 -7.26144 30.0328 -22.846 -163 1 1.56438 12.1819 3.32547 9.10171 15.3717 9.49092 -164 2 1.376 11.5384 2.66679 -5.32309 -27.3061 -8.25977 -165 2 1.61002 12.9703 2.79202 3.36268 15.5511 3.76031 -166 1 0.549815 17.2556 4.8751 10.3167 15.4421 -19.2536 -167 2 -0.00199658 17.9163 5.26632 -10.5855 22.2192 -2.30371 -168 2 0.434878 16.519 5.43169 0.723696 -37.6018 20.4622 -169 1 1.10394 1.00198 9.3932 22.7427 9.86492 -7.57605 -170 2 1.42144 0.685439 10.2466 -8.09769 -6.36772 6.76546 -171 2 0.213433 0.697197 9.27667 -15.9263 -9.88137 4.21803 -172 1 16.7947 2.33275 13.2864 3.73194 4.84267 -27.3174 -173 2 17.0439 2.54012 12.3481 -6.98409 -4.39606 26.1758 -174 2 16.4729 1.42155 13.294 0.162444 -0.657512 2.21945 -175 1 2.4659 15.8297 12.1956 27.3811 -11.2673 13.1923 -176 2 2.9226 15.5311 13.0144 -9.82996 7.11615 -19.573 -177 2 2.93231 15.4201 11.4444 -5.86947 6.23921 4.54204 -178 1 16.4361 15.5441 5.94616 -3.08145 19.3328 -8.8947 -179 2 17.3593 15.4783 6.2724 -11.5576 7.7283 -8.52746 -180 2 16.3183 16.2893 5.29043 11.1937 -18.2696 22.1006 -181 1 5.84475 5.01999 11.7951 -3.08481 -3.45829 -4.75382 -182 2 5.52388 5.87345 12.0737 0.2772 11.9484 7.56792 -183 2 5.11411 4.43946 12.0133 1.47645 -8.9756 -0.689037 -184 1 15.224 4.86392 0.726277 -25.4938 -12.7349 25.4219 -185 2 14.7355 4.51715 1.53205 23.492 12.9767 -22.6649 -186 2 14.5328 5.02763 18.7193 1.17802 2.78752 1.94947 -187 1 16.3449 16.2967 2.11437 10.483 7.37611 -22.6614 -188 2 15.9997 16.7982 2.83675 -10.4405 6.50893 22.1211 -189 2 16.6677 16.9984 1.52582 -1.93062 -9.0043 0.169523 -190 1 0.302094 4.87802 3.79689 -13.2533 37.9479 3.00012 -191 2 0.313912 5.8808 3.95538 6.86913 -44.9842 -7.10747 -192 2 1.1462 4.49233 4.0346 3.71094 3.5442 4.02727 -193 1 2.9221 14.9895 15.0397 8.46471 -6.33736 14.5665 -194 2 3.00495 14.6058 15.9566 -9.31495 16.4585 -22.1508 -195 2 2.45729 15.8402 15.0938 1.85721 -3.29548 9.95349 -196 1 1.12 14.5717 9.56227 17.989 48.8934 -19.0037 -197 2 2.07414 14.5222 9.32346 -20.956 -13.4859 7.84449 -198 2 0.791626 13.7731 9.9282 4.87275 -29.8773 11.3577 -199 1 13.6624 16.6636 11.5457 -10.5327 9.77879 -22.0557 -200 2 13.3286 17.4311 11.0186 6.18992 -14.9435 17.5347 -201 2 13.3805 15.8992 11.021 -2.34987 0.215756 7.80532 -202 1 4.73359 1.47857 0.718618 -25.3973 -6.06392 2.87887 -203 2 4.17185 2.00661 0.129453 7.95287 0.81937 2.61464 -204 2 4.09095 0.858388 1.12753 14.212 5.94905 -1.43657 -205 1 1.42476 18.4735 11.9056 -5.99404 19.5083 -8.93412 -206 2 1.23513 0.382953 12.6723 -0.378912 0.915416 0.341246 -207 2 1.89505 17.7259 12.2433 7.21066 -16.1249 4.04173 -208 1 11.5448 10.106 4.11346 25.2596 15.8213 -25.5125 -209 2 11.5283 10.5663 3.22641 -2.70186 -14.3529 26.6987 -210 2 12.5027 10.081 4.37886 -27.2068 -0.404219 -8.52489 -211 1 8.37485 12.1748 3.75184 -11.9448 24.9759 46.3975 -212 2 9.17743 12.5878 4.11803 1.10724 -8.54244 -18.9118 -213 2 7.75197 12.4339 4.49102 7.61965 -18.0915 -33.0697 -214 1 14.3244 4.03247 3.293 11.3964 4.48411 20.4985 -215 2 14.943 4.18459 4.05162 -10.8147 -3.75721 -20.4981 -216 2 13.4909 4.45368 3.55282 4.29688 -1.92648 -2.70238 -217 1 5.58313 1.77339 7.50694 -37.3093 -46.6507 29.7736 -218 2 4.97145 1.12464 8.0478 36.2685 39.0776 -31.448 -219 2 5.37556 1.59155 6.57949 1.79923 3.69516 -0.386563 -220 1 17.9058 1.11523 4.88403 9.14173 18.8744 -7.73144 -221 2 18.4454 1.57607 4.20954 -6.0377 -15.1011 6.62684 -222 2 17.7347 1.81107 5.53023 -2.74058 -7.94095 2.09707 -223 1 6.8279 9.39776 4.48823 3.62694 -0.974221 -6.28613 -224 2 6.84568 9.51125 5.43283 -7.5389 4.30482 14.2207 -225 2 7.717 9.07508 4.31798 2.90721 -0.358573 -8.96695 -226 1 2.70207 14.9601 1.96467 9.48597 -9.94138 -22.1344 -227 2 3.35633 14.7518 2.62888 0.238693 -0.206349 10.2383 -228 2 3.16249 14.7444 1.12616 -13.7934 7.99556 12.9651 -229 1 17.2754 12.8959 13.1352 7.09139 -37.5845 3.69594 -230 2 16.3537 13.1102 13.3148 3.80173 19.6017 -1.81888 -231 2 17.838 13.6507 12.9698 -8.26303 20.1956 -1.14982 -232 1 15.0171 10.5799 1.38486 -27.8548 -28.8799 -20.6854 -233 2 15.5438 11.2121 1.82149 21.7425 28.5078 17.6295 -234 2 14.2994 11.069 0.967203 2.72678 -1.55793 4.42244 -235 1 5.71388 6.94387 4.52744 5.06868 -23.5408 12.0019 -236 2 5.87421 7.87915 4.41499 3.45829 8.88765 -0.888191 -237 2 6.40286 6.63416 5.14703 -8.303 0.627238 -7.76707 -238 1 8.10838 8.26645 10.1831 -2.58942 7.80898 11.2224 -239 2 8.62669 8.8788 9.66253 10.4484 9.83111 7.1505 -240 2 7.63286 7.80673 9.50478 -12.057 -13.4779 -6.03182 -241 1 13.5281 18.2914 5.80176 -22.4215 -1.8227 14.6872 -242 2 12.749 0.212336 5.63336 9.50875 -1.85743 -1.68773 -243 2 13.2346 17.7232 6.55015 8.07385 12.1374 -16.5266 -244 1 0.320637 2.55746 0.113707 -24.4854 52.0087 1.52013 -245 2 18.0083 2.70852 18.6241 7.28296 -16.9077 1.12853 -246 2 0.626424 3.4996 0.197011 8.79214 -31.4205 1.87945 -247 1 12.6453 10.9632 9.76861 -25.4211 42.834 -14.9231 -248 2 11.6492 10.8795 9.70071 37.3368 -7.50244 3.90461 -249 2 13.0228 10.1402 10.0352 -3.08107 -28.1376 6.91694 -250 1 0.78452 12.2807 11.0864 19.7349 -6.9692 -1.93691 -251 2 18.4749 12.3028 11.1225 -11.4863 3.49833 6.83674 -252 2 1.15231 12.659 11.9029 -10.6903 -3.95248 -3.68276 -253 1 5.04293 7.22507 13.482 3.09598 5.99749 -4.73795 -254 2 5.58886 7.93262 13.132 -0.232718 7.71962 -10.0141 -255 2 5.52798 7.00144 14.2755 -0.932575 -7.50807 9.86229 -256 1 1.28071 6.97469 11.8373 -31.3117 -37.3004 -11.5925 -257 2 0.492113 7.17802 11.3051 9.94401 -3.39318 6.90536 -258 2 1.685 7.80152 11.9673 18.2328 34.095 8.03536 -259 1 15.4541 9.47192 12.3133 5.85738 22.5951 5.06509 -260 2 15.5175 10.4638 12.3742 -4.62374 -31.0112 4.63394 -261 2 15.4968 9.06746 13.1992 -1.35817 12.6181 -10.5463 -262 1 16.6442 12.9519 5.45538 -21.4717 15.277 -31.3145 -263 2 16.3435 13.8787 5.41602 10.8128 -9.57177 19.5795 -264 2 16.428 12.7198 4.52965 10.5011 -15.0883 17.3079 -265 1 6.17539 10.0558 0.19339 -10.2788 -9.80575 -26.1597 -266 2 5.38875 10.4515 0.589333 6.07089 -1.52504 2.9393 -267 2 6.86188 10.0925 0.84877 11.0601 2.17112 10.8149 -268 1 12.366 6.05676 4.0416 -22.1854 -19.7968 12.9024 -269 2 12.3704 6.78834 3.44644 3.0333 22.1434 -14.5586 -270 2 11.4296 5.77117 4.03801 16.8285 0.174707 3.6691 -271 1 0.132536 12.8255 0.204274 -0.526736 3.63462 -3.55478 -272 2 -0.0162245 13.5547 0.824079 2.12041 -2.82991 -1.20796 -273 2 18.2367 13.045 18.0704 5.31007 -1.26571 4.82883 -274 1 3.83823 18.58 8.61434 -10.0824 -4.97514 -18.4016 -275 2 3.52069 18.2861 7.74382 9.30441 -4.40092 2.94392 -276 2 3.03757 0.306881 8.974 -6.88025 7.19874 10.2509 -277 1 7.39362 17.2775 4.45212 12.7302 8.58303 13.7229 -278 2 7.99666 17.968 4.81801 -14.6435 -15.1886 -20.2263 -279 2 7.36047 17.3088 3.48385 6.79225 7.50625 8.12072 -280 1 9.21958 17.0373 12.2266 15.7968 3.09867 9.11932 -281 2 9.35553 16.2013 11.7334 2.65662 13.4997 9.89778 -282 2 10.0046 17.242 12.8046 -16.9951 -13.4125 -19.4407 -283 1 13.3157 13.0082 7.94027 -17.3901 -31.9016 7.67948 -284 2 13.1929 12.2449 8.54147 -2.27359 6.97807 -8.06923 -285 2 14.1396 13.3907 8.1966 15.275 17.864 3.60781 -286 1 14.9833 2.94943 15.3513 6.95235 -3.03472 -25.2367 -287 2 14.3042 2.39498 14.9448 0.627233 -0.993788 8.39197 -288 2 15.6656 2.99789 14.6444 -10.442 2.78752 17.6131 -289 1 9.85751 15.5027 17.0048 6.47201 6.54967 -7.92386 -290 2 10.2825 14.6779 16.7304 0.0104739 2.25127 2.62159 -291 2 9.29444 15.3215 17.7618 -3.54568 -3.88732 3.90928 -292 1 11.2881 8.2507 16.5469 4.08161 11.4658 1.26949 -293 2 10.784 7.71518 15.9432 -10.4144 -1.78397 -10.2593 -294 2 11.7122 7.60386 17.1014 6.56418 -3.83522 10.5232 -295 1 3.78473 18.1936 16.723 -4.68023 16.7202 -12.0174 -296 2 4.25527 17.5912 17.2966 7.9068 -1.91441 12.6846 -297 2 3.78787 0.451609 17.087 5.31404 -15.3334 2.54941 -298 1 2.1979 4.10843 8.95106 26.9406 -12.5237 33.2314 -299 2 3.04044 3.62982 8.81286 -17.1971 13.1508 -10.8815 -300 2 2.16124 4.09638 9.93984 -10.9226 5.8942 -24.7105 -301 1 9.90906 10.3512 9.74092 -24.4032 35.3078 2.18412 -302 2 9.42476 11.1784 9.45919 17.314 -27.1904 0.11143 -303 2 9.91744 10.4013 10.7102 5.12409 -5.92526 -7.2544 -304 1 9.73754 0.812356 10.8589 -9.45704 -2.93658 -4.01088 -305 2 9.44076 18.5949 11.1517 4.40065 -9.39685 13.0528 -306 2 9.08713 0.996724 10.1835 0.761981 14.6946 -8.69624 -307 1 9.19301 15.2105 10.2107 -22.2036 -10.0383 -7.82623 -308 2 8.98025 16.0713 9.80369 1.46967 -14.8527 4.99479 -309 2 8.36662 14.6679 10.1029 23.0402 13.9843 6.10558 -310 1 0.991303 9.28993 10.3284 48.5242 0.758788 -7.3086 -311 2 1.23965 10.2015 10.4879 -14.9681 11.3684 1.41472 -312 2 1.89881 8.9146 10.1688 -36.1698 0.796544 3.16897 -313 1 16.8183 4.88742 8.19443 14.5542 -10.1877 33.2312 -314 2 16.1728 5.34475 8.77937 11.7085 -6.30946 -17.3069 -315 2 17.4003 4.3619 8.8005 -18.9368 13.5764 -18.1776 -316 1 14.6428 14.6932 0.395223 -8.43601 -1.47433 8.87339 -317 2 15.0319 15.2579 1.0921 -3.12605 -9.09789 -8.18687 -318 2 13.8519 14.2576 0.787234 16.4944 11.1317 -8.84191 -319 1 3.51972 11.0527 9.63241 -0.0258339 11.398 -8.76826 -320 2 3.50143 11.4368 10.5206 2.13389 -0.105265 -4.21661 -321 2 3.1724 11.7459 9.02999 3.72912 -11.0816 8.2725 -322 1 11.0404 10.8634 1.27208 6.70694 17.4362 -9.49329 -323 2 11.1727 11.6824 0.735781 1.31404 -20.4369 14.6488 -324 2 10.1116 10.6362 1.15363 0.362803 -1.95542 1.92755 -325 1 13.2201 7.06705 12.8916 -20.9652 2.88797 -6.38338 -326 2 14.1438 6.85164 12.9216 15.9393 -3.58362 1.12932 -327 2 12.7477 6.22232 12.897 3.28641 3.49729 -0.863357 -328 1 9.62872 1.89177 0.948251 6.96093 0.24991 16.0649 -329 2 8.76715 2.00519 0.577625 -19.1552 -2.18542 -3.65809 -330 2 10.1854 1.76875 0.19003 12.4655 1.79214 -8.44775 -331 1 10.594 13.5319 4.7375 16.0423 -1.41644 13.6035 -332 2 11.415 13.0379 4.93682 -11.8157 3.93147 -13.4525 -333 2 10.5255 14.1008 5.52348 -3.94863 -4.31219 -11.1546 -334 1 14.2685 1.70153 10.8945 -3.08057 3.85383 7.15216 -335 2 15.0552 1.23258 10.5836 3.50278 10.8149 -1.53255 -336 2 14.4104 2.66429 10.8947 7.37053 -8.35752 -2.77651 -337 1 14.6611 12.4198 11.7249 1.4364 -26.5965 -56.3444 -338 2 15.4897 12.4837 11.202 -5.7241 6.85295 22.6084 -339 2 14.0924 11.9909 11.0313 1.01548 12.4899 31.9742 -340 1 8.24953 5.08668 9.79072 -30.3058 0.287699 22.814 -341 2 7.41708 5.03925 10.3073 16.545 17.0491 -5.32162 -342 2 8.22462 4.2143 9.42755 11.9131 -18.3304 -16.4659 -343 1 1.59402 16.8187 18.3253 -6.20255 31.6963 -6.78121 -344 2 1.91227 17.2067 17.482 -4.95179 -10.2412 13.7563 -345 2 1.83336 15.9037 18.3179 8.32765 -17.6711 -3.36436 -346 1 1.43897 17.2464 15.3358 29.6054 -7.17934 -6.21787 -347 2 1.36087 18.1379 15.637 5.97318 20.4573 7.89508 -348 2 0.556137 16.9475 15.3273 -33.612 -15.1267 -3.09538 -349 1 3.72895 5.57357 6.20543 -8.92972 12.8219 1.61975 -350 2 3.23079 6.21113 6.76482 10.0758 -7.74032 -14.0976 -351 2 4.28418 6.06511 5.5772 -4.67021 4.78615 6.0759 -352 1 12.3529 9.4251 14.1822 19.6727 -43.1834 10.5387 -353 2 12.884 8.61082 13.8993 -22.621 36.8155 4.19437 -354 2 12.0516 9.14148 15.0731 3.60544 11.6456 -14.396 -355 1 4.03531 15.2728 6.90881 24.4865 3.71204 -3.62934 -356 2 3.44033 16 6.68284 5.60112 1.73001 -3.29651 -357 2 4.96253 15.5542 6.68078 -28.8575 -4.96404 7.1648 -358 1 0.605953 8.56457 14.8638 -0.120582 -0.391313 3.99343 -359 2 0.501042 9.52227 15.005 5.35221 -7.46858 -4.68281 -360 2 1.25554 8.44629 14.1506 -6.09669 6.93914 6.70414 -361 1 12.9734 8.36578 10.3368 20.5003 -18.2509 -7.79226 -362 2 13.7393 7.86937 9.99522 -8.8873 10.1321 -9.444 -363 2 12.9708 8.03443 11.231 -10.3099 3.90117 14.6287 -364 1 15.2894 7.6332 3.49269 12.7581 18.2329 -13.143 -365 2 14.5338 7.17315 3.08677 6.1918 -0.800492 21.6775 -366 2 15.5136 7.51531 4.43453 -15.4019 -14.7068 -6.3771 -367 1 17.3212 6.64473 0.0316567 -27.1824 12.6283 -1.8657 -368 2 16.771 5.99448 0.499966 9.26154 0.672542 -4.32476 -369 2 16.64 7.24337 18.2783 17.9792 -11.5061 8.92142 -370 1 8.80668 6.92454 7.83918 -24.3908 -17.2325 7.20576 -371 2 9.68081 7.28212 7.80962 25.7376 5.86496 2.86911 -372 2 8.71775 6.37228 8.64787 6.10597 9.33115 -12.275 -373 1 12.3202 0.615137 1.17425 13.6931 -3.72396 -2.19539 -374 2 13.075 0.992886 1.63957 -0.40119 2.44364 5.09949 -375 2 12.7571 18.5667 0.666384 -10.9298 0.853201 -1.96514 -376 1 5.6785 15.1027 14.5126 8.23045 15.6484 -5.86338 -377 2 4.72039 15.1784 14.5966 0.299323 4.01186 0.94539 -378 2 6.04535 15.9236 14.1081 -12.4379 -14.8055 10.7649 -379 1 3.83406 6.52943 1.68496 -5.12703 10.9404 0.999964 -380 2 3.44824 7.31709 1.2662 3.88585 -11.3877 -2.55221 -381 2 3.84338 6.82178 2.59771 5.33619 -6.06857 7.79227 -382 1 3.88904 11.6132 12.2401 8.95627 -8.79814 -2.40389 -383 2 4.75841 12.0277 12.3683 -7.0992 0.0294616 4.018 -384 2 3.233 12.1226 12.7151 -2.84239 9.6423 6.84851 -385 1 5.44987 3.87776 15.8711 9.04603 51.7105 12.2927 -386 2 5.99752 3.20763 15.4917 15.5436 -17.9801 -7.19396 -387 2 6.04703 4.69158 15.9698 -28.7283 -34.9666 -5.01916 -388 1 14.4605 10.3225 4.39641 11.4537 -30.5762 -31.9722 -389 2 14.8306 9.83502 5.14205 -5.39586 2.29688 2.9797 -390 2 14.6901 9.75629 3.58792 -12.4512 26.4694 34.1579 -391 1 7.94485 17.2962 9.23406 -29.3852 32.3044 -4.90329 -392 2 7.20157 17.582 9.8013 11.6936 -12.8295 -3.21694 -393 2 7.93254 17.9646 8.52624 8.85814 -10.3239 0.926379 -394 1 4.49873 14.4249 3.9575 27.1774 17.1098 41.9883 -395 2 4.83669 15.3326 4.20793 -17.2661 -25.1881 -14.2087 -396 2 4.80599 13.8528 4.71739 -13.53 13.4591 -29.2523 -397 1 14.3284 7.3854 15.7629 16.5671 6.07561 9.97379 -398 2 15.2454 7.23106 15.4511 -19.609 3.15959 8.32151 -399 2 14.4426 7.80786 16.6389 -4.4507 -8.27801 -15.1382 -400 1 2.87403 18.2247 1.90389 13.9577 30.3231 32.1513 -401 2 2.546 17.6397 1.25326 -17.0615 -24.6646 -23.5795 -402 2 2.12038 18.5502 2.43008 9.19244 -2.23706 -9.85686 -403 1 7.96361 1.60549 4.53489 27.0952 14.1367 0.307488 -404 2 7.49638 1.9472 3.77739 -15.4877 0.180801 -4.55719 -405 2 8.8215 2.06687 4.46869 -11.5471 -13.5362 7.94734 -406 1 2.67177 14.1298 17.7578 -32.0965 -17.6674 6.84649 -407 2 1.82063 13.6639 17.9969 26.9839 12.0838 -7.18622 -408 2 3.38659 13.5743 18.1098 -5.52669 6.70603 -3.66321 -409 1 0.723551 1.68725 13.8621 17.7332 3.27009 -2.43746 -410 2 0.829271 1.51069 14.7908 7.98206 -4.95309 12.0999 -411 2 18.44 1.84118 13.7764 -20.4783 4.25661 -8.09669 -412 1 4.55406 18.6 13.9636 17.2604 -7.63309 -9.35161 -413 2 5.43897 18.1924 13.8214 -18.4623 11.1021 3.79828 -414 2 4.32329 18.399 14.8757 -4.15164 0.0521115 2.41255 -415 1 7.10455 0.474046 18.3679 -11.2359 27.2348 29.1061 -416 2 7.12016 0.115813 17.4965 -1.63433 -6.1865 -23.0052 -417 2 6.24271 0.910062 18.5515 12.5771 -12.8936 -7.91243 -418 1 16.1005 18.44 14.1333 -36.4501 -27.5791 -6.57953 -419 2 15.3829 17.8174 13.8465 25.6281 20.8019 -1.7164 -420 2 15.9077 18.5395 15.0719 9.49834 8.44163 -0.14337 -421 1 10.1046 4.52059 16.2893 -46.9792 2.1543 -16.8809 -422 2 11.0012 4.49779 16.5541 31.7343 -4.51398 5.87687 -423 2 9.86248 3.65729 15.9089 12.0807 6.21086 8.83226 -424 1 15.8363 17.9271 4.41684 -16.1004 8.03032 22.5493 -425 2 16.5039 18.6299 4.52246 -8.60661 -6.24751 -1.3813 -426 2 15.0378 18.2098 4.9532 29.0614 -11.0784 -22.6438 -427 1 6.9284 17.3613 13.7353 43.359 11.4946 7.60179 -428 2 7.46858 17.7163 14.5015 -21.3841 -13.8198 -23.6549 -429 2 7.59514 17.216 13.0184 -16.6797 3.36376 18.1603 -430 1 13.2847 6.56451 6.73769 -14.228 -11.1924 -15.3605 -431 2 14.2169 6.67596 6.68467 27.6084 8.49537 10.422 -432 2 13.086 6.40899 5.80997 -14.9004 -1.60425 -0.509451 -433 1 7.67719 2.38409 9.18276 -12.7481 -9.95901 -21.449 -434 2 7.23781 2.34079 10.0234 -2.84678 0.492631 19.9336 -435 2 6.97018 2.11077 8.55354 21.5545 6.86467 6.74712 -436 1 15.1528 14.8764 13.6487 -19.1236 6.62595 6.09279 -437 2 14.9964 15.042 14.5941 6.3649 -1.885 -8.0702 -438 2 14.3208 15.1168 13.2045 14.5757 -4.46306 2.19701 -439 1 9.29857 8.33432 3.70772 10.6355 -8.13532 4.49802 -440 2 10.1502 8.81328 3.76286 -8.0776 -10.0517 2.73632 -441 2 9.46492 7.39019 3.89736 0.427871 14.9166 -2.52044 -442 1 17.6858 13.4785 16.4504 18.1421 12.8824 -2.9019 -443 2 16.7336 13.3749 16.3876 -0.564153 6.32044 -4.53985 -444 2 17.9415 14.3223 16.0098 -13.7235 -15.3212 6.57805 -445 1 5.04165 10.6569 2.59879 15.0811 -13.5005 18.1704 -446 2 5.79991 10.2916 3.10884 -13.8602 3.81488 -12.1379 -447 2 4.57944 11.1735 3.25148 -7.64374 9.33605 4.93504 -448 1 3.71156 8.35988 10.3223 2.69392 -10.4458 7.32 -449 2 3.86762 9.29314 10.1995 2.90356 12.3134 -9.75827 -450 2 3.79851 8.25131 11.2818 -4.19061 -2.88345 -8.87222 -451 1 16.1009 7.11278 6.31821 6.57165 -19.5926 -13.3215 -452 2 16.7556 7.67982 6.75754 -3.32154 -9.30994 -6.24555 -453 2 16.5222 6.22545 6.20359 -10.7974 20.4957 5.39095 -454 1 15.1877 7.01217 9.11633 -0.942582 31.3193 -31.4924 -455 2 16.0087 7.4094 9.45282 -9.93766 -6.26011 -0.320925 -456 2 15.0368 7.51069 8.25256 3.47491 -21.9129 34.3614 -457 1 6.44498 13.1525 12.9077 -4.11711 1.46333 8.37594 -458 2 7.24124 12.6683 13.1519 -1.65948 -2.61146 -1.33868 -459 2 6.29723 13.796 13.6274 -0.63037 -8.66373 -16.4588 -460 1 12.122 4.49686 13.0678 27.186 16.1548 19.2119 -461 2 12.2551 4.61131 14.0219 7.12074 5.87928 -4.56992 -462 2 11.3374 3.99971 13.0395 -36.5276 -21.5475 -13.6693 -463 1 11.3413 8.18743 7.85231 -9.00357 4.77407 0.37365 -464 2 12.0188 7.6639 7.39095 2.25052 4.68793 14.2505 -465 2 11.6381 8.44006 8.74837 5.13859 -10.097 -12.5363 -466 1 17.1781 10.7776 7.41775 8.98079 -10.5429 4.93206 -467 2 17.827 10.053 7.20793 -14.7505 26.0455 -2.01259 -468 2 17.1485 11.4724 6.73654 6.61625 -12.2683 -1.04931 -469 1 5.23072 18.1435 11.0535 -19.1878 -10.0323 -1.26774 -470 2 4.70405 18.0783 11.8789 8.35901 -0.713622 -15.9457 -471 2 4.65273 17.8196 10.3204 13.2116 10.9899 16.482 -472 1 7.5638 17.6255 1.82385 0.18941 -4.57957 5.58349 -473 2 7.78527 16.8134 1.38126 5.66428 -18.4097 -0.230917 -474 2 7.45334 18.2192 1.09148 -1.66074 15.0057 -4.75644 -475 1 1.8616 12.9257 13.6096 9.14642 8.79388 9.51824 -476 2 1.6025 12.3584 14.3568 1.58601 7.25854 -8.04733 -477 2 2.19519 13.7677 13.9951 -8.21693 -20.1216 -3.01678 -478 1 9.73071 6.79429 14.803 -9.96431 20.7294 -5.24946 -479 2 9.965 5.93538 15.1079 4.49059 -29.2435 15.7374 -480 2 10.0131 6.81015 13.8895 1.7202 7.35701 -8.16934 -481 1 15.2073 4.3815 10.7753 5.02149 -7.87008 -1.3136 -482 2 16.102 4.07091 10.8622 12.544 -14.2164 -8.54624 -483 2 15.2461 5.11302 11.375 -14.5847 15.9831 9.57625 -484 1 11.1932 6.12384 0.161263 5.03411 2.82645 3.69768 -485 2 11.3288 5.17786 0.364595 -11.2178 11.9329 -9.49937 -486 2 10.2678 6.33084 18.566 9.25768 -12.2342 6.14633 -487 1 0.186838 11.3278 15.1363 -29.5173 30.1692 -23.1318 -488 2 18.3705 11.8565 14.4078 15.8912 -24.6881 20.4884 -489 2 18.5399 11.8236 15.9183 6.48048 -3.45982 -2.85079 -490 1 7.07004 9.14522 7.26474 -13.1186 -12.9635 8.90657 -491 2 6.53932 8.3872 7.60207 7.2147 19.6305 -8.47997 -492 2 7.95552 8.78183 7.22801 5.51641 0.721385 -0.901037 -493 1 18.4462 15.4465 12.3531 0.397712 -4.42488 4.01328 -494 2 0.764911 15.5581 12.2944 -10.8471 -1.16552 -3.91149 -495 2 18.1036 15.6779 11.4829 2.90793 1.2817 1.1609 -496 1 16.5729 4.36464 5.24677 -25.0478 -7.96005 29.4563 -497 2 16.6771 3.95228 6.15287 5.89012 16.1194 -31.2199 -498 2 17.3789 4.38374 4.73556 17.0857 -2.87844 2.77648 -499 1 17.7776 3.07164 10.7152 20.2072 1.91324 7.6701 -500 2 0.0768882 3.1314 10.9751 -16.1773 7.43675 -1.86825 -501 2 17.7244 2.20926 10.3009 -7.90603 -5.17093 -4.6179 -502 1 12.3097 0.0632784 10.17 -5.23585 14.9609 -0.662134 -503 2 11.3669 0.329281 10.3192 28.4735 0.874848 -0.34084 -504 2 12.8997 0.858518 10.2668 -24.0851 -21.9241 -3.33166 -505 1 10.3626 9.82488 12.3121 10.8795 10.4681 17.7395 -506 2 11.1241 9.87716 12.9295 -11.9387 -4.40292 -9.54779 -507 2 10.179 8.8911 12.2253 1.1465 -9.5921 -0.185536 -508 1 0.479623 2.83009 7.02164 2.3472 21.5918 -9.19818 -509 2 0.779466 3.61946 7.51564 -3.03286 -18.4976 -0.625243 -510 2 0.704445 2.06385 7.54355 5.66126 -3.27927 9.79357 -511 1 0.467007 15.244 6.91284 -2.81724 -38.2268 -9.44322 -512 2 0.589986 15.6097 7.78713 1.11258 -6.7374 10.833 -513 2 0.615386 14.2454 7.00377 -3.57496 47.8567 -6.78063 -514 1 16.9531 7.01102 15.3314 25.0955 -6.26352 -3.35293 -515 2 17.7312 7.54015 15.1398 -4.24099 15.1997 -5.49373 -516 2 17.3882 6.19624 15.5982 -13.584 -8.29127 -0.013797 -517 1 9.00968 12.4205 8.1448 -47.4595 3.97518 -14.6445 -518 2 9.255 11.8265 7.44329 24.3825 -11.7648 -7.05727 -519 2 8.04408 12.5071 7.93332 27.0995 7.32888 21.0703 -520 1 1.26609 1.94093 3.05591 2.05426 9.79258 -12.831 -521 2 1.21698 2.59367 2.33971 -7.6512 -12.9321 3.35408 -522 2 1.90984 2.32941 3.65026 1.81811 -2.05605 5.16186 -523 1 4.13335 15.1162 9.63732 -3.37236 0.94273 -0.929026 -524 2 4.11982 15.1465 8.67375 -6.81504 5.04573 1.04836 -525 2 4.9784 14.712 9.81623 8.98269 -4.0071 9.77097 -526 1 7.18021 2.17978 14.5671 7.55504 9.68183 9.47496 -527 2 6.93575 1.71258 13.7681 -0.50379 0.233559 -6.02908 -528 2 7.66352 2.97784 14.2972 -3.4628 -8.48803 0.116771 -529 1 18.6085 14.7119 2.15295 17.2538 -25.5542 -3.98016 -530 2 0.854482 15.0949 2.23403 -8.04084 1.8593 -0.311551 -531 2 17.9464 15.3611 2.33256 -11.9957 20.7574 3.41759 -532 1 9.94838 2.78838 12.9451 -1.38176 -12.4025 -13.9087 -533 2 9.76343 2.19068 12.1969 8.49761 3.03822 8.73498 -534 2 9.19943 3.38599 12.9407 -2.82035 8.06337 4.45668 -535 1 2.81023 8.91387 13.015 -11.0947 -9.09099 -1.03322 -536 2 3.12702 9.79437 12.8576 7.30933 17.7942 -2.89213 -537 2 3.52626 8.44288 13.432 10.5553 -8.83156 6.15268 -538 1 3.22981 8.35572 3.63929 7.91603 12.3414 59.3292 -539 2 3.55022 9.08279 3.12704 6.39159 12.4302 -19.4578 -540 2 3.47038 8.64809 4.58003 -14.7797 -20.4427 -37.089 -541 1 5.63158 7.19787 8.5111 -16.5836 -10.0318 8.45115 -542 2 5.49703 6.26423 8.32413 12.2862 -3.4998 -5.25722 -543 2 4.92977 7.35667 9.15199 5.58983 12.4707 2.72685 -544 1 14.8806 1.27947 2.01044 -5.20911 -29.6221 -13.7523 -545 2 14.8531 1.98102 2.64457 3.54145 24.2946 3.1913 -546 2 15.2413 1.51873 1.14568 -0.321243 12.6895 5.96264 -547 1 8.23741 15.1928 0.849855 10.5438 9.56485 -11.8122 -548 2 9.03414 15.1092 1.40038 -9.07879 -4.36113 3.60062 -549 2 7.50349 14.6875 1.21874 4.98636 -2.78068 7.26539 -550 1 15.6325 1.34538 7.23629 -19.2726 -10.6819 -7.69516 -551 2 14.9548 0.715658 6.87861 16.0521 20.279 9.35294 -552 2 15.1584 2.15623 7.4957 0.78871 -9.00488 -4.70177 -553 1 4.90948 13.0908 18.526 11.7484 -4.19917 14.2638 -554 2 5.32661 13.1046 0.771936 -5.81675 2.26251 -17.1314 -555 2 5.47193 13.6353 17.9612 2.08739 -3.03703 1.40027 -556 1 15.3444 8.47528 18.1477 10.5782 11.2904 -17.9652 -557 2 15.7712 9.10441 17.5134 -10.1785 -13.1115 16.9911 -558 2 15.2549 8.94211 0.342082 0.277618 5.95495 -1.45242 -559 1 12.072 3.0348 18.3713 9.16845 -16.043 3.97866 -560 2 11.9997 2.53228 0.532204 -11.5106 10.3924 18.501 -561 2 12.5782 2.36842 17.9104 5.62845 7.32417 -26.0863 -562 1 13.2089 12.6783 5.18015 6.63876 -6.29032 2.85699 -563 2 13.7391 11.9795 4.78379 -2.73226 -0.00342211 -8.22979 -564 2 13.3831 12.5487 6.11225 -3.40081 8.86391 8.40941 -565 1 6.04915 7.04527 0.0350485 10.8742 -21.2203 -4.52865 -566 2 6.02805 7.99092 18.6226 -5.46576 23.9499 6.727 -567 2 5.33859 6.76219 0.618839 -5.51003 3.35157 1.33709 -568 1 17.7393 16.0214 15.0094 13.9302 -13.9422 41.059 -569 2 16.9573 16.5339 15.2303 -2.65419 1.12677 -17.6965 -570 2 17.9199 15.9264 14.0844 -11.8828 6.17072 -25.9912 -571 1 13.1897 1.00209 16.5482 9.0285 -11.9403 8.82412 -572 2 14.1531 0.926941 16.6936 -12.5978 2.36886 -2.70952 -573 2 12.8801 0.0805392 16.5939 -0.793518 8.62378 -3.88342 -574 1 11.1147 14.5676 7.20714 13.0879 22.2032 -16.1382 -575 2 10.392 14.3041 7.74555 -20.7251 -13.6554 17.189 -576 2 11.8256 13.9392 7.33494 4.5733 -4.90634 5.95678 -577 1 17.5119 8.63301 2.08454 0.0660302 9.5119 10.6671 -578 2 16.6736 8.51459 2.527 -7.33525 3.37542 8.64387 -579 2 17.5132 7.89769 1.49414 7.23803 -17.2019 -20.825 -580 1 12.3543 7.99739 2.01665 -2.5776 9.38468 -13.8973 -581 2 12.1955 8.87571 1.62365 2.26325 -8.37679 12.9533 -582 2 11.9634 7.39841 1.37453 -1.21895 -7.08079 -1.91625 -583 1 11.8862 14.6191 10.3431 -20.5633 -33.2885 -21.2052 -584 2 12.048 13.7971 9.8109 4.18347 28.6601 18.3667 -585 2 10.9021 14.6739 10.3387 21.4811 7.86907 3.51893 -586 1 6.88785 7.04202 15.6064 18.5625 21.2571 16.3476 -587 2 7.79496 7.28653 15.325 -16.282 -10.9681 -3.58347 -588 2 6.76913 7.58838 16.4136 -4.66142 -14.4555 -17.927 -589 1 8.00173 4.72633 13.4744 30.8534 11.0647 12.2619 -590 2 7.23536 4.76996 12.9314 -21.7993 1.23146 -17.3356 -591 2 8.43981 5.59806 13.3773 -8.25054 -18.6352 3.63378 -592 1 13.408 12.1818 14.2607 -3.38159 -13.7589 -5.77775 -593 2 13.0599 11.273 14.209 4.17969 5.9499 4.9999 -594 2 13.8015 12.3234 13.3884 0.552928 6.09909 4.73433 -595 1 14.8332 9.42219 7.30259 -3.18701 -8.441 -7.55641 -596 2 15.6639 9.86655 7.42287 15.173 5.4083 -0.0492361 -597 2 14.1987 10.0431 7.62107 -17.8235 6.30723 6.71627 -598 1 12.6528 17.0596 3.07812 -8.70602 18.4808 5.33985 -599 2 12.9496 17.4673 3.92869 -9.46791 -7.74089 -22.4319 -600 2 12.0101 17.6853 2.63014 23.5323 -19.7514 22.4129 -601 1 1.16198 7.14088 17.4585 -7.06812 8.47411 -13.2553 -602 2 0.305081 7.19087 17.9183 5.00325 -4.47293 -7.14563 -603 2 1.04973 7.54449 16.5661 0.440843 -6.25707 18.2149 -604 1 12.7703 5.1502 15.6519 20.537 -9.206 9.03076 -605 2 13.4569 4.49661 15.9358 -13.2491 19.9411 -11.3493 -606 2 13.2029 6.02791 15.5919 -0.675517 -15.6076 2.74775 -607 1 2.52973 3.39372 4.98628 -12.5021 24.9114 40.8727 -608 2 1.78336 3.12225 5.60975 27.8197 11.256 -19.0698 -609 2 2.94772 4.23746 5.36491 -19.3389 -38.1774 -13.5008 -610 1 8.3189 11.2987 13.4496 33.0028 -42.3062 59.2485 -611 2 8.52043 10.9592 14.374 -32.1909 27.8732 -26.3694 -612 2 9.06111 10.8351 13.0577 -1.72326 7.29715 -30.1092 -613 1 12.8789 1.33643 13.3362 0.40834 22.0058 -3.21803 -614 2 13.4118 1.44301 12.5159 -13.2456 3.30889 14.5055 -615 2 12.3632 2.16071 13.5095 17.0122 -18.2145 -15.4576 -616 1 6.34323 13.7037 2.15004 -8.90275 3.4942 1.01633 -617 2 5.67068 13.9831 2.80896 17.8093 -8.54249 -8.97759 -618 2 6.94017 13.0667 2.55763 -1.44693 0.407866 6.84109 -619 1 15.9207 6.60938 12.7941 -14.0219 -16.6873 -1.46208 -620 2 16.3665 7.21966 12.2297 10.4548 13.0291 -14.3606 -621 2 16.4032 6.61209 13.6164 4.57404 0.312906 11.3916 -622 1 16.837 0.713429 9.59537 -4.60186 -23.2491 -5.40047 -623 2 16.7766 18.3812 9.76009 1.861 23.059 -1.51736 -624 2 16.4539 0.846132 8.70764 2.52408 0.807103 8.64662 -625 1 6.14677 11.7538 8.37929 1.46343 -38.2042 -1.58984 -626 2 5.28119 11.5099 8.79312 19.6536 2.3972 -11.55 -627 2 6.62627 10.8955 8.13754 -23.51 30.7545 10.2414 -628 1 2.89887 8.61954 0.44521 -58.0253 1.44029 -30.8084 -629 2 2.28026 8.19904 18.4406 35.2092 -5.33136 7.34884 -630 2 2.23436 9.22701 0.790296 19.604 11.6332 17.9417 -631 1 10.1646 10.4607 6.5042 -2.67562 1.82661 -6.4385 -632 2 10.6119 9.73033 6.95167 0.990091 1.19991 -1.59039 -633 2 10.4858 10.4732 5.58284 -1.09389 -1.85789 13.424 -634 1 6.73063 15.6946 6.55447 -0.851851 -4.83477 5.20485 -635 2 7.09829 16.1491 7.32752 1.36873 0.436433 -10.1699 -636 2 7.02842 16.1335 5.74515 1.47904 6.69628 7.42626 -637 1 6.44804 13.1708 5.58287 -3.43311 -13.1021 10.8705 -638 2 6.66139 13.9646 6.07673 2.2473 5.97996 0.728386 -639 2 6.06157 12.5687 6.2363 0.868112 2.44944 -5.20285 -640 1 16.8203 12.5595 9.83963 -1.29973 -13.3798 -26.0882 -641 2 16.9797 11.9255 9.1094 -0.187484 2.38257 16.1818 -642 2 16.6351 13.3676 9.36293 0.809528 9.54538 5.72824 -643 1 6.04152 2.95052 2.84999 -1.13024 -25.4835 15.2707 -644 2 6.4006 3.79327 2.62573 5.01416 22.8678 -12.9444 -645 2 5.58314 2.5656 2.09763 0.434854 2.67004 -8.58918 -646 1 10.9107 3.32852 3.29939 -12.4238 -2.51051 -2.149 -647 2 10.2568 3.99067 3.55961 5.98057 0.0707186 3.553 -648 2 10.4887 2.88551 2.55708 3.841 -3.98893 -4.96007 -ITEM: TIMESTEP -20 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.69334 7.07477 17.9589 0.0661907 -8.15672 -5.93801 -2 2 7.76544 6.892 18.1438 2.06168 0.344835 4.67083 -3 2 8.87494 6.58302 17.1494 0.0923072 2.18051 2.08263 -4 1 18.5724 8.27759 6.8487 9.68108 -9.0135 5.9796 -5 2 0.0748736 7.96696 5.95521 0.0469709 2.78304 -15.7461 -6 2 0.399795 7.62446 7.38749 -2.21574 6.41883 6.02377 -7 1 8.4 18.5641 6.8134 3.87483 8.82198 -0.0595031 -8 2 9.32611 0.166963 6.70047 -3.24105 -1.28376 -0.166563 -9 2 7.89494 0.641414 6.41149 2.5055 -2.76566 0.153015 -10 1 6.59225 1.83896 11.6912 -0.275689 0.302437 5.80014 -11 2 5.92509 2.27303 12.2308 -4.07131 5.9643 -4.10931 -12 2 6.1821 1.00166 11.4658 -1.55571 -7.95905 -4.17259 -13 1 7.1255 5.73378 2.34451 -23.1841 27.0209 10.5427 -14 2 6.64356 6.29382 2.99422 10.5833 -21.9235 -2.45439 -15 2 6.93596 6.23963 1.54379 8.61204 -12.4491 -6.79559 -16 1 16.2118 10.162 16.1238 9.73263 11.3036 -6.58381 -17 2 17.0956 10.2901 15.7587 -2.05967 -6.96031 3.12171 -18 2 15.9212 11.066 16.279 -7.86411 -1.51367 3.55804 -19 1 10.6155 15.0016 2.3147 2.6864 2.11515 1.56294 -20 2 10.6002 14.5314 3.15674 -2.41534 -3.03603 0.679536 -21 2 11.0785 15.8209 2.51731 -0.0195897 0.981381 0.0978469 -22 1 17.1585 8.25197 10.4305 1.44624 0.93325 5.78222 -23 2 16.6499 8.94547 10.8694 -0.557047 -3.86734 3.9084 -24 2 18.0092 8.65295 10.2197 -0.225121 0.250414 -1.13708 -25 1 14.8741 15.8852 16.3481 -7.08493 -6.82471 0.413246 -26 2 13.9679 16.1979 16.3007 -7.09092 5.8218 -2.34027 -27 2 14.8494 15.2418 17.0641 6.82868 3.48864 5.90805 -28 1 12.1588 13.3817 0.433178 -6.27467 12.7595 -4.80914 -29 2 12.0352 13.6324 18.1551 4.79076 -7.76922 -3.88045 -30 2 11.6846 14.0735 0.910169 -3.08866 -6.36125 10.7585 -31 1 9.27449 5.40778 4.04397 -13.9365 -16.0184 3.55858 -32 2 8.80012 5.02015 4.81047 7.30704 13.9384 -9.37026 -33 2 8.62496 5.33174 3.3181 9.32114 8.483 4.67507 -34 1 1.82732 4.26294 11.6464 -4.04254 -2.69427 0.93532 -35 2 1.77693 5.20244 11.8864 -0.000737327 -7.07977 -0.141665 -36 2 2.24287 3.78422 12.3753 -0.858945 2.71416 -2.4423 -37 1 1.98268 6.82933 8.36887 -4.76513 2.22844 -15.7156 -38 2 2.36253 7.23451 9.15103 4.34961 -4.46197 5.21996 -39 2 2.01952 5.87123 8.47722 1.07428 0.125821 9.68028 -40 1 5.39566 4.39684 7.93565 8.0799 8.40992 8.79829 -41 2 5.46014 3.43633 8.01893 -3.87159 0.552259 -10.4859 -42 2 4.76986 4.63893 7.2446 -2.8004 -4.28351 -0.196723 -43 1 3.26324 2.92599 17.538 -6.48526 11.4036 5.90093 -44 2 3.9521 3.41084 17.0519 -4.33162 -2.5567 2.49087 -45 2 2.74469 3.58038 18.0606 14.1441 -6.64194 -12.4081 -46 1 7.47828 5.27232 6.10849 -6.04695 1.38866 -9.34596 -47 2 7.88111 5.94624 6.68322 -4.96979 -11.9122 3.47667 -48 2 6.82246 4.73008 6.58045 9.57964 11.031 7.72945 -49 1 9.77144 7.02208 11.9904 4.73189 -1.1383 -1.06285 -50 2 10.3467 6.38126 11.5734 3.30689 -2.46386 0.831607 -51 2 9.14216 7.24941 11.3005 -7.52384 3.80108 0.31383 -52 1 14.0798 3.55416 8.05513 -3.28328 4.35009 -1.93857 -53 2 13.7004 4.26501 7.52877 0.673114 -0.544944 -0.0617854 -54 2 14.5392 3.99696 8.77439 -0.252332 -0.945414 2.55344 -55 1 4.73763 17.2389 4.01031 -0.321378 8.61877 -17.0141 -56 2 5.59566 17.6635 4.11691 -0.835388 -5.76098 7.55997 -57 2 4.38449 17.6475 3.19969 -7.45685 -7.93836 11.3283 -58 1 16.5107 16.6056 10.0759 6.54448 8.81329 9.76337 -59 2 15.9397 16.7408 10.8388 -5.01232 -5.78767 -1.53078 -60 2 15.9723 16.2069 9.3894 -4.78788 -4.31379 0.495659 -61 1 1.96746 4.90416 0.450775 -1.81832 7.5424 0.20662 -62 2 2.57813 5.33173 1.07474 -1.76589 -7.7088 -3.71938 -63 2 1.58349 5.65244 18.6136 5.80255 -6.17515 -0.843526 -64 1 11.7761 13.343 16.2841 -6.04701 8.80367 11.8739 -65 2 11.2992 12.5177 16.4849 4.5736 1.77316 -11.3497 -66 2 12.2862 13.2596 15.4658 -7.12668 -12.5479 1.29578 -67 1 10.1128 11.0591 16.9331 1.69597 -16.074 1.546 -68 2 10.529 10.1874 17.0807 -3.30995 11.3925 -3.21813 -69 2 9.18388 10.849 16.7697 3.68635 3.27029 -1.84825 -70 1 11.7127 17.5197 13.4648 11.3019 2.11475 -5.22831 -71 2 12.331 17.0869 12.8651 -0.203424 -4.77186 2.96515 -72 2 11.9976 18.4453 13.422 -5.71015 -0.897636 4.76739 -73 1 6.35333 9.30557 12.2266 11.9787 8.60001 -4.91149 -74 2 6.91868 9.08658 11.4768 -7.06745 -10.6307 -2.02859 -75 2 6.87303 9.9972 12.642 -2.68502 3.03115 9.09234 -76 1 16.2229 12.7446 2.69624 -0.291567 -17.1772 2.14859 -77 2 17.0444 13.127 2.38556 1.82795 9.93981 0.639945 -78 2 15.5737 13.4355 2.84522 -0.398116 10.9003 -3.52894 -79 1 0.630414 12.571 5.87324 -2.78001 5.23525 -2.09291 -80 2 1.00794 12.4159 4.99822 -5.49855 2.79722 0.151968 -81 2 18.3568 12.8603 5.70082 10.405 -7.04854 2.54099 -82 1 5.20787 16.4001 18.4776 -12.5497 0.602195 -7.10426 -83 2 5.86464 15.8156 18.076 4.18722 4.70251 6.39081 -84 2 5.5918 16.9091 0.552483 9.38889 -4.76533 -0.723228 -85 1 0.52849 7.63403 4.08589 29.1287 17.8407 -12.6947 -86 2 18.5836 7.90722 3.36083 3.6478 2.13346 8.06342 -87 2 1.42012 8.03877 3.86645 -30.4536 -16.431 6.17599 -88 1 3.1381 8.91119 6.51072 -13.5755 -1.26875 13.9192 -89 2 3.59199 8.61596 7.312 -0.196935 0.713487 -8.34602 -90 2 2.19086 8.84537 6.73861 12.9731 1.00292 -6.41375 -91 1 7.31254 10.3111 16.1924 3.71601 3.69021 9.41051 -92 2 6.5835 10.5117 15.6001 -2.45726 -1.05124 6.16708 -93 2 6.97924 10.3433 17.1122 -4.5268 -1.10556 -13.1914 -94 1 11.1003 1.05051 4.99797 5.80988 -5.62906 14.1745 -95 2 11.3837 1.86623 4.56736 -9.38615 -1.44268 -8.87945 -96 2 10.7526 0.427875 4.34338 1.37635 7.2616 -4.61902 -97 1 4.41216 2.72626 13.196 4.39031 -15.812 27.2385 -98 2 4.68873 3.14242 14.0209 1.29771 13.5884 -6.24163 -99 2 4.35373 1.80262 13.5146 -5.93981 4.62314 -19.463 -100 1 8.39633 10.0477 1.8021 8.65231 5.58991 3.9521 -101 2 8.43584 10.7505 2.47552 -3.18527 -5.8592 -1.95349 -102 2 8.78245 9.25294 2.20632 -6.17245 6.11296 -0.869653 -103 1 10.5167 1.74791 15.5607 -12.987 -0.969766 6.95693 -104 2 11.4294 1.4693 15.6846 2.64548 4.13814 -6.20872 -105 2 10.3497 1.97094 14.6365 5.88046 -1.13362 -2.56443 -106 1 2.75172 12.9341 7.77038 -1.98364 -2.25212 -7.11701 -107 2 3.34024 13.5411 7.30753 1.72417 1.81116 5.40918 -108 2 2.20386 12.578 7.06153 -5.53374 1.90184 4.06344 -109 1 3.65904 11.6762 5.27167 1.4745 3.00351 -5.43274 -110 2 3.4246 11.0613 5.97769 -1.9036 -0.651658 -6.95213 -111 2 2.87422 11.8691 4.73548 4.37313 -4.77202 2.40024 -112 1 6.8497 14.4837 16.8623 -7.20011 -2.9268 7.54224 -113 2 7.64382 13.9472 16.8068 -1.68272 1.48794 -3.62778 -114 2 6.45279 14.5388 15.9848 5.36951 2.03983 -1.60361 -115 1 14.1732 14.5515 3.40534 8.00808 -4.71428 -5.83886 -116 2 13.686 15.3662 3.26714 -6.11485 0.946493 -0.0166146 -117 2 13.6673 13.9759 3.98664 -1.2314 3.40033 5.39954 -118 1 8.29912 18.1674 16.0589 -20.5282 -4.34905 -0.197762 -119 2 8.7408 17.3576 16.3653 13.9085 14.9544 -3.06277 -120 2 8.83266 0.312858 15.8727 12.6636 -13.3116 3.05514 -121 1 4.73053 1.62244 4.91728 3.73461 17.8941 -9.82498 -122 2 3.87083 2.07692 4.90413 8.70323 -5.84393 3.64668 -123 2 5.31846 2.19299 4.38363 -11.3635 -9.88313 3.69576 -124 1 15.0998 12.7921 16.4359 -16.5392 5.6559 5.83964 -125 2 14.613 13.1569 17.1797 9.93151 -3.40376 10.0434 -126 2 14.4182 12.7815 15.762 4.3611 -9.31248 -14.0367 -127 1 15.7898 18.3971 16.8042 5.79346 -1.22695 27.8179 -128 2 16.3329 18.5498 17.6117 -9.65553 4.21222 -20.1346 -129 2 15.4648 17.4968 16.9407 3.00983 3.14177 -9.23088 -130 1 1.14588 1.15091 16.5513 6.84042 -4.63386 -6.55399 -131 2 1.94328 1.67743 16.706 -5.62204 0.173811 5.06431 -132 2 0.528577 1.37004 17.2554 5.0728 5.5861 0.922174 -133 1 18.0913 4.5707 15.884 4.25376 -5.47852 -1.15194 -134 2 18.5654 4.01411 15.2573 -2.45188 0.25544 1.09753 -135 2 18.6545 4.64521 16.6589 -1.38654 0.113736 -2.45626 -136 1 12.2253 16.9711 16.1412 0.914186 -11.4555 3.91466 -137 2 11.5632 16.3741 16.5429 5.70701 14.4982 -7.43821 -138 2 12.0767 16.9746 15.1851 -6.52552 1.11271 2.73005 -139 1 15.9091 2.53324 17.9911 -0.813861 17.5084 -1.21546 -140 2 15.6764 3.36649 18.4268 1.17892 -6.2644 3.50604 -141 2 15.6868 2.72575 17.0644 4.5424 -10.5093 4.50867 -142 1 6.70264 13.8034 10.241 3.67042 13.5267 -3.47207 -143 2 6.65382 13.63 11.1889 -2.71481 -10.4168 -1.32753 -144 2 6.64075 12.981 9.74212 -1.13183 -3.39045 4.84834 -145 1 10.1303 18.2368 2.79334 3.88934 4.25391 -9.05815 -146 2 10.3528 0.228802 2.09034 -3.74927 -2.61302 6.3793 -147 2 9.24556 17.9143 2.58077 2.23777 4.46644 1.38681 -148 1 2.97822 17.7592 6.09436 6.84514 -11.0569 -16.6755 -149 2 2.2147 17.6257 5.53291 -18.2595 3.26089 9.16469 -150 2 3.66284 17.6557 5.427 11.9633 8.77303 4.67614 -151 1 12.5626 16.9639 7.98676 12.5848 -1.11028 -8.52053 -152 2 11.8839 16.2724 7.94525 -2.9484 9.81966 4.92503 -153 2 12.3706 17.6612 8.63222 -7.85492 -11.7975 4.91014 -154 1 14.885 15.2749 8.26678 1.09184 -13.1129 19.8008 -155 2 14.1202 15.8628 8.27106 1.10724 6.83397 -10.769 -156 2 15.4286 15.3633 7.48102 -5.52588 8.50153 -14.3957 -157 1 17.5862 18.2834 0.376986 -24.9344 -1.23553 -1.17468 -158 2 18.3469 17.8479 0.005767 18.8411 -2.89863 0.907383 -159 2 17.8259 0.448151 0.831731 10.0339 0.947456 -0.506579 -160 1 0.885899 10.3809 1.40397 7.22911 -11.5028 6.53987 -161 2 0.114071 9.81378 1.55479 0.851643 9.57639 -0.353744 -162 2 0.635753 11.1007 0.824785 -9.84019 7.34982 -5.0696 -163 1 1.59112 12.2023 3.3355 8.42913 -7.93475 21.5428 -164 2 1.38243 11.4488 2.766 -0.926106 10.11 -6.99043 -165 2 1.6499 13.0233 2.84482 -2.64968 -0.879455 -11.853 -166 1 0.551086 17.2511 4.8776 21.276 -3.63263 -24.3978 -167 2 -0.0762795 17.9651 4.97462 -6.3407 4.63135 13.3725 -168 2 0.558623 16.612 5.58807 -10.7338 -2.48853 14.1039 -169 1 1.11389 0.976548 9.40441 -9.70348 2.26791 0.52143 -170 2 1.20067 0.739298 10.3296 11.5619 -5.66825 6.05541 -171 2 0.194683 0.747268 9.24308 -0.993818 -3.51563 -8.196 -172 1 16.7801 2.33697 13.2827 1.26658 -2.58515 -3.42214 -173 2 16.9917 2.52603 12.3542 -2.2694 -1.44301 7.47438 -174 2 16.5315 1.40163 13.3451 -1.6586 3.84983 -3.29893 -175 1 2.50653 15.8317 12.198 6.9942 0.0378495 -5.39106 -176 2 3.03319 15.4932 12.933 -2.33393 0.151651 -5.20129 -177 2 2.92041 15.5438 11.3652 -1.63849 1.19534 6.62391 -178 1 16.4211 15.5676 5.95733 20.9565 28.2944 1.83954 -179 2 17.3426 15.5843 6.27645 -8.81355 -7.9692 1.26231 -180 2 16.3612 16.4166 5.46885 -9.28613 -17.0928 2.60564 -181 1 5.82453 5.03389 11.7824 5.33446 0.320875 1.57619 -182 2 5.57998 5.74431 12.3877 -7.39983 3.16893 -2.12011 -183 2 5.27405 4.27426 12.0034 -1.54313 1.61628 -0.196815 -184 1 15.2115 4.85871 0.718957 -12.3292 -1.21553 20.1953 -185 2 14.9951 4.64926 1.65891 1.99725 2.35951 -19.8125 -186 2 14.3839 5.18637 18.9796 8.05664 -2.8997 2.32554 -187 1 16.3489 16.3233 2.11444 -1.37403 -13.232 -8.15517 -188 2 15.9103 16.7203 2.87049 4.10511 7.42013 3.0617 -189 2 16.5474 17.0218 1.48672 0.743353 6.63736 2.3016 -190 1 0.282027 4.87119 3.80055 19.2835 17.3487 3.53091 -191 2 0.489613 5.83173 3.76503 -11.8967 -17.4303 3.14809 -192 2 1.11089 4.48306 4.11838 -9.18259 -2.61174 -2.176 -193 1 2.9303 15.0125 15.0392 0.0573492 -0.181072 31.7668 -194 2 2.82615 14.584 15.9186 6.41531 2.15453 -14.4377 -195 2 2.5906 15.8967 15.228 -6.81336 0.182398 -11.4579 -196 1 1.12223 14.6049 9.5632 13.1187 -18.7351 -0.898815 -197 2 1.97867 14.3698 9.19328 2.71847 14.7063 -6.21023 -198 2 0.940175 13.7592 9.98602 -14.9991 7.00648 6.43026 -199 1 13.665 16.6454 11.5316 -21.8339 3.0331 3.55613 -200 2 13.1746 17.4327 11.223 10.4467 -7.06131 -5.36321 -201 2 13.1002 15.9021 11.2581 8.49503 1.30575 -4.9094 -202 1 4.71709 1.47693 0.719081 -0.792104 -2.26487 7.67979 -203 2 4.13723 2.08795 0.242023 0.0358417 -6.61504 -0.0652634 -204 2 4.16248 0.903426 1.27536 -1.89276 3.42768 -9.42283 -205 1 1.43372 18.4947 11.8904 0.435024 0.903574 -5.06079 -206 2 1.25876 0.369488 12.6813 0.171373 0.403899 4.07674 -207 2 1.76959 17.6363 12.1756 0.0129122 3.12302 0.145238 -208 1 11.5344 10.1145 4.09755 11.0508 4.0163 -22.2825 -209 2 11.4066 10.5292 3.21014 2.38528 -6.34716 18.1192 -210 2 12.5036 10.0411 4.22804 -15.2135 3.993 -1.98571 -211 1 8.36281 12.1777 3.74701 -13.1943 -6.81146 -12.1909 -212 2 9.18722 12.6378 3.9579 -8.09176 1.3179 12.2751 -213 2 7.70079 12.2682 4.46238 18.0882 5.10492 -3.45512 -214 1 14.3344 4.02288 3.28855 15.2498 3.93213 6.6836 -215 2 15.0617 4.23514 3.91062 -12.0049 -4.72392 -3.76747 -216 2 13.5379 4.47251 3.60621 4.75183 0.0120405 -3.02562 -217 1 5.58434 1.74596 7.50985 -22.3692 -26.8297 9.12948 -218 2 4.91823 1.11394 7.92632 27.2868 23.8434 -15.8784 -219 2 5.43743 1.67946 6.54893 -3.28939 1.24453 9.56906 -220 1 17.9012 1.11073 4.88195 -3.31078 -7.47428 -4.80941 -221 2 18.5525 1.45486 4.25184 -3.70144 3.91348 6.86656 -222 2 17.7599 1.74881 5.59037 4.24211 2.13046 -3.7457 -223 1 6.8304 9.4053 4.48372 -13.6803 0.789023 -7.06041 -224 2 6.74666 9.48009 5.43928 9.48337 1.88908 4.46236 -225 2 7.74899 9.21301 4.27057 2.55497 -2.6247 5.048 -226 1 2.68932 14.9418 1.9668 -6.12139 1.43036 2.89635 -227 2 3.30587 14.7185 2.6759 1.77318 0.618157 -6.66396 -228 2 3.15681 14.9246 1.12432 2.70839 -4.47578 5.21755 -229 1 17.2859 12.889 13.1454 -5.46423 18.1991 -4.92566 -230 2 16.4361 13.3067 13.278 -15.9577 -14.9195 9.16742 -231 2 17.7285 13.6846 12.8505 24.3586 -1.49654 -2.29875 -232 1 15.0069 10.5712 1.38624 -2.11062 -3.1818 -0.491761 -233 2 15.5786 11.255 1.74854 2.03128 0.359313 2.4477 -234 2 14.2323 11.0405 1.08579 -5.34855 2.20107 -0.889893 -235 1 5.70672 6.90314 4.53443 4.24519 -5.28557 8.89432 -236 2 5.96576 7.83558 4.52332 0.860976 -3.32444 -1.54743 -237 2 6.34045 6.45199 5.11743 -0.773999 0.740319 -5.54545 -238 1 8.07933 8.28074 10.2171 -3.64639 -3.67369 23.1077 -239 2 8.76707 8.87858 9.90894 -2.7343 3.77639 -10.7375 -240 2 7.6749 7.81667 9.48055 2.86655 5.40525 -7.79011 -241 1 13.5084 18.3075 5.79227 -0.609935 12.5659 -0.945985 -242 2 12.8781 0.387145 5.63591 -2.7451 -9.905 0.332396 -243 2 13.1846 17.8335 6.57076 -1.7745 -1.29433 -5.46225 -244 1 0.277736 2.58212 0.118598 0.621477 -2.00702 8.56184 -245 2 17.957 2.7127 18.6839 10.2871 11.0559 -0.501636 -246 2 0.794319 3.38844 0.33639 -19.4232 -4.52538 -3.88061 -247 1 12.6801 10.9983 9.7602 -12.9965 -11.6862 -0.561246 -248 2 11.7228 10.8953 9.6485 6.19444 12.5166 -3.56604 -249 2 12.897 10.0826 9.9647 14.0656 0.707903 4.64438 -250 1 0.781933 12.2574 11.0872 -6.04901 -2.18816 6.07288 -251 2 18.4712 12.3682 11.1342 -4.62852 -2.97634 -7.25325 -252 2 1.06266 12.4852 11.9795 7.76729 1.60409 -2.26455 -253 1 5.05561 7.24886 13.466 -11.4852 -6.03635 -4.86876 -254 2 5.50236 8.03712 13.1394 10.7241 -0.576345 -1.34855 -255 2 5.49314 6.97472 14.2774 5.89817 7.37955 3.96262 -256 1 1.26581 6.94402 11.8396 4.62667 -0.613543 7.50244 -257 2 0.504801 7.20295 11.3208 -2.84364 2.86798 -1.49635 -258 2 1.66495 7.76854 12.1529 -2.34869 -3.61795 -5.23307 -259 1 15.4733 9.48228 12.3076 -4.70583 25.6475 16.0975 -260 2 15.3149 10.4406 12.4106 2.52372 -12.0579 -11.0564 -261 2 15.3983 9.16189 13.2139 2.67764 -6.7615 -6.72177 -262 1 16.6336 12.9201 5.4628 6.66579 -20.8603 16.0577 -263 2 16.5173 13.872 5.54201 -7.55482 0.841067 -13.5204 -264 2 16.4587 12.5944 4.56908 -1.3904 13.4091 -1.6671 -265 1 6.18458 10.0203 0.145227 10.7922 -3.52818 2.39688 -266 2 5.51531 10.431 0.700604 -4.05423 0.759005 -2.7608 -267 2 6.99302 10.1148 0.667984 -1.67417 -4.19008 -1.28624 -268 1 12.3589 6.06668 4.038 0.452115 -1.15559 12.336 -269 2 12.2616 6.902 3.56852 -2.7325 -0.676505 -9.18667 -270 2 11.4806 5.67315 4.10483 0.607886 2.8799 -4.57435 -271 1 0.151536 12.8218 0.203335 4.13456 -2.94622 -2.33064 -272 2 -0.0129983 13.5003 0.871422 4.06521 1.52419 -2.90371 -273 2 18.34 13.1254 18.0507 -1.07008 -0.669132 2.22617 -274 1 3.8124 18.585 8.59267 3.71655 -0.510361 5.11861 -275 2 3.56708 18.0759 7.80793 -6.58546 5.02297 1.51156 -276 2 3.01311 0.371537 8.92178 -4.29721 -3.94788 -5.16471 -277 1 7.41673 17.2735 4.46563 5.27699 16.8729 -12.8498 -278 2 7.96434 18.0381 4.66458 -2.5447 -1.66977 13.1327 -279 2 7.34622 17.3735 3.5102 -3.86431 -11.0257 -0.167405 -280 1 9.22722 17.0589 12.2393 19.2623 -14.5641 0.108859 -281 2 9.27149 16.2912 11.647 -4.87121 6.1965 2.03703 -282 2 10.0709 17.0037 12.729 -13.5572 10.6592 -2.64279 -283 1 13.3059 12.9585 7.95053 -5.93488 5.61094 -2.56551 -284 2 13.3162 12.2379 8.59837 1.79032 5.44422 0.740585 -285 2 13.8923 13.6822 8.21069 6.53108 -7.176 5.15054 -286 1 14.9676 2.9565 15.3436 -0.386658 0.574387 3.68052 -287 2 14.4202 2.18777 15.1252 1.77471 7.19316 -4.43588 -288 2 15.6633 3.03092 14.6718 -7.27619 -4.52831 0.823712 -289 1 9.86266 15.5244 17.0043 3.51131 -4.56125 -2.22878 -290 2 10.4016 14.759 16.7592 -3.4195 -0.793849 -1.98877 -291 2 9.23782 15.2217 17.674 1.65588 4.18023 5.21634 -292 1 11.2982 8.26605 16.5436 5.00814 15.3472 3.18516 -293 2 10.6561 7.79454 16.0057 0.999826 -4.04983 -0.0472571 -294 2 11.6606 7.65108 17.1873 -4.09078 -4.29715 -0.00155616 -295 1 3.81225 18.1964 16.7292 10.4788 2.16731 8.30533 -296 2 4.28955 17.5863 17.3008 -0.586781 -10.0924 -3.62086 -297 2 3.8829 0.368785 17.226 -6.17555 6.78007 -4.03101 -298 1 2.19803 4.12169 8.95254 -8.42555 5.0907 -8.8117 -299 2 3.07539 3.82533 8.67919 -2.6088 -0.1453 11.8715 -300 2 2.06404 4.00225 9.90658 13.5851 0.597917 -5.47855 -301 1 9.88178 10.3569 9.73038 4.79618 9.75255 -1.56513 -302 2 9.58096 11.2105 9.34815 0.270313 -13.7408 11.2463 -303 2 10.0884 10.4563 10.6769 -5.68787 3.60286 -6.41077 -304 1 9.72212 0.809424 10.8539 19.6856 13.2875 8.50656 -305 2 9.35568 18.6419 11.2241 -8.56647 -0.801274 -6.22283 -306 2 9.1718 1.19131 10.1642 -10.1616 -7.34852 -1.36201 -307 1 9.20808 15.1775 10.2123 -15.4381 -3.13199 6.73164 -308 2 8.85567 15.9769 9.80113 1.42232 -2.21967 -3.83769 -309 2 8.41617 14.6283 10.3808 11.8702 3.92611 -8.2586 -310 1 0.995689 9.3369 10.3259 -16.0333 -0.722577 -1.64132 -311 2 1.04111 10.3025 10.3672 11.5337 -2.90556 1.12718 -312 2 1.85551 8.94205 10.1494 2.50931 13.4523 1.23502 -313 1 16.8622 4.87275 8.19393 -0.422934 0.254968 7.2846 -314 2 16.1689 5.44633 8.57547 10.3862 -6.79292 -0.962882 -315 2 17.2033 4.29721 8.90095 -5.62498 7.92604 -8.45296 -316 1 14.656 14.7011 0.368319 0.981504 1.6367 -2.03469 -317 2 15.1464 15.0731 1.12238 -4.61865 -0.709772 -8.09446 -318 2 13.8079 14.3976 0.718239 6.88081 -1.79732 0.157513 -319 1 3.54139 11.054 9.61635 4.40574 2.25524 -6.23941 -320 2 3.65641 11.5568 10.4349 -3.33961 -4.79202 -0.629126 -321 2 3.06202 11.6341 9.00365 5.95536 0.511998 4.3162 -322 1 11.0657 10.8474 1.29636 2.92174 -3.12366 4.90686 -323 2 11.2982 11.6263 0.767958 -3.5102 -3.65436 5.75862 -324 2 10.1232 10.6698 1.15822 5.54645 2.63321 -1.67034 -325 1 13.2072 7.07995 12.8701 -0.715054 4.17079 -6.48984 -326 2 14.1512 6.89692 12.9697 -2.29399 1.70307 -2.36257 -327 2 12.7789 6.22148 12.7926 -0.519741 -2.64677 3.01569 -328 1 9.62848 1.89714 0.960589 0.144249 -1.27383 8.14422 -329 2 8.75389 1.7191 0.595255 2.62606 0.878667 -4.42234 -330 2 10.2646 1.96201 0.242782 -4.84565 1.17493 -5.89222 -331 1 10.5889 13.5223 4.7138 2.80012 2.67941 -15.7349 -332 2 11.4734 13.1444 4.59356 -4.0194 -1.02806 11.2737 -333 2 10.6142 14.0248 5.53615 3.92037 -3.05166 -0.671 -334 1 14.2891 1.71547 10.914 14.736 9.54636 -9.28817 -335 2 15.0906 1.40219 10.4788 -2.27816 -10.6125 3.67971 -336 2 14.438 2.66833 10.8812 -8.3278 1.7804 6.62982 -337 1 14.6539 12.3888 11.7057 -9.85382 -5.79197 9.84531 -338 2 15.5174 12.4906 11.2689 -13.4179 -5.72309 -9.10321 -339 2 13.9464 12.0325 11.1297 19.1264 4.07718 -1.67851 -340 1 8.24463 5.07042 9.80489 8.67652 16.3821 0.210642 -341 2 7.41075 5.25266 10.2586 0.116202 -10.888 -2.54867 -342 2 8.19641 4.23298 9.33202 -10.3006 -5.74151 5.58561 -343 1 1.57762 16.8331 18.335 1.68687 -2.26048 -0.033424 -344 2 1.80587 17.1847 17.4697 -0.252498 3.71983 1.68741 -345 2 2.01633 15.9753 18.3429 -7.29056 -3.61139 0.997127 -346 1 1.4432 17.2346 15.332 2.65894 -7.35401 -5.7102 -347 2 1.56202 18.0921 15.7447 -7.04866 6.37518 1.22888 -348 2 0.495246 17.0477 15.225 10.7628 4.03376 7.259 -349 1 3.71499 5.60328 6.17396 -2.46237 18.0728 1.59518 -350 2 3.14409 6.20568 6.67532 2.19379 -7.75625 0.984178 -351 2 4.32024 6.21155 5.72591 -1.08806 -7.05296 -5.84211 -352 1 12.3532 9.43776 14.1893 13.0079 -11.8089 -5.25996 -353 2 12.7562 8.63341 13.7793 -8.52026 15.4152 14.9752 -354 2 12.1872 9.21442 15.1219 0.0848175 -4.0166 -10.4276 -355 1 4.03165 15.279 6.91423 11.4052 5.55751 -7.84178 -356 2 3.54353 15.996 6.48767 -3.99323 -1.71496 7.04649 -357 2 4.96733 15.4866 6.74143 -6.91754 -4.3684 4.91577 -358 1 0.598678 8.56195 14.8837 5.20406 11.6905 0.774862 -359 2 0.593362 9.51845 15.0326 -4.59172 -3.85379 3.33684 -360 2 1.20863 8.47913 14.1435 0.530109 -4.80423 2.60663 -361 1 12.9822 8.33824 10.332 -12.7812 8.13505 -15.7365 -362 2 13.7449 7.91273 9.91994 1.65618 -4.07378 8.99333 -363 2 12.9305 8.07685 11.2552 9.52621 -6.7264 2.9301 -364 1 15.3077 7.66451 3.49902 -16.235 -26.2008 20.478 -365 2 14.5457 7.14577 3.24297 -4.72624 11.0142 -23.2354 -366 2 15.4625 7.21195 4.33822 21.3334 18.0327 3.91528 -367 1 17.3129 6.65992 0.0418436 1.52354 1.06354 -1.27952 -368 2 16.9014 5.84978 0.373955 -3.48337 6.90323 -1.87832 -369 2 16.58 7.23266 18.3971 4.62858 -6.17573 2.16922 -370 1 8.83009 6.92284 7.82744 0.252992 -5.92817 5.57761 -371 2 9.76137 7.15634 7.81451 4.22584 7.3373 -3.58966 -372 2 8.73794 6.33872 8.59756 -2.97854 -0.622916 -4.66555 -373 1 12.3396 0.625886 1.18148 -8.16379 -0.652746 9.01197 -374 2 13.1345 0.755236 1.71568 4.24005 -1.61972 -8.33969 -375 2 12.5055 18.5332 0.58867 3.80642 2.13695 -0.293066 -376 1 5.66619 15.1148 14.5143 -6.5884 11.0519 3.391 -377 2 4.74474 15.2404 14.7783 -0.0534379 -6.99417 -3.01637 -378 2 5.9729 15.9975 14.2655 4.1321 -4.56061 -2.72375 -379 1 3.84883 6.51764 1.70764 -0.24517 -12.2729 -5.84301 -380 2 3.34882 7.24325 1.31145 3.38543 6.95106 5.25371 -381 2 3.97654 6.73657 2.63696 -3.88246 4.168 -0.0932901 -382 1 3.88114 11.6142 12.2659 5.57001 4.81087 6.19714 -383 2 4.75444 11.9544 12.4977 1.45427 -2.38077 -3.49117 -384 2 3.27884 12.2304 12.6965 -5.21243 -4.02352 0.863052 -385 1 5.43603 3.86764 15.8623 7.54926 19.6814 5.52869 -386 2 6.13377 3.21124 15.7334 -3.30504 1.34649 -4.68995 -387 2 5.89589 4.73554 15.9355 -10.2176 -19.0214 -2.32011 -388 1 14.4546 10.3201 4.4055 -4.6195 -17.8145 -6.66778 -389 2 14.5894 9.8066 5.2203 1.29615 2.58376 -6.73886 -390 2 14.6351 9.71867 3.64602 0.226975 12.0799 18.4878 -391 1 7.91148 17.3357 9.20787 -1.7112 -7.64626 2.59046 -392 2 7.14677 17.4921 9.78359 1.89149 7.49144 -9.53339 -393 2 7.98506 17.9868 8.49476 -7.16328 0.988414 5.46347 -394 1 4.5072 14.4394 3.95775 1.71054 11.4257 7.67338 -395 2 4.60793 15.3916 4.19235 0.708777 -20.878 -0.615863 -396 2 4.75094 13.8726 4.71695 -2.09911 13.0171 -9.33913 -397 1 14.3103 7.38832 15.7657 0.217846 1.64546 9.18842 -398 2 15.2433 7.23588 15.5844 -0.0812074 1.42566 -0.574095 -399 2 14.3036 7.75428 16.6621 0.0607731 -0.988243 -5.21848 -400 1 2.8988 18.2304 1.89629 8.58281 11.0644 9.98123 -401 2 2.46496 17.5082 1.44481 -2.59003 -3.64619 -8.76243 -402 2 2.19471 18.7603 2.28641 0.940953 -0.0494932 1.95923 -403 1 7.97286 1.6093 4.54004 -3.7555 -8.8471 12.6183 -404 2 7.33734 2.04506 3.96057 8.79876 5.02214 -6.32296 -405 2 8.86006 1.965 4.43164 -2.78989 3.02833 -7.03085 -406 1 2.61876 14.1356 17.7492 -10.3822 -13.3904 -3.64852 -407 2 1.93119 13.4601 17.9363 9.46205 16.209 2.13837 -408 2 3.45643 13.7285 18.0162 -4.37303 1.24885 0.341178 -409 1 0.743255 1.70456 13.8731 3.59522 3.89384 -8.23695 -410 2 0.90651 1.38191 14.7629 -6.62821 1.47751 3.8543 -411 2 18.4338 1.82907 13.7582 5.96409 -0.15878 4.57237 -412 1 4.54424 18.6047 13.95 -3.57477 5.05027 -2.13798 -413 2 5.48468 18.3837 13.9843 -5.3566 -3.00882 -0.547935 -414 2 4.15141 18.3634 14.8001 4.77528 1.99072 0.545271 -415 1 7.0969 0.526127 18.3635 1.96349 3.45814 -4.17057 -416 2 7.27221 0.201121 17.4702 1.10961 -1.44826 4.33327 -417 2 6.13787 0.588122 18.4485 3.2238 7.1666 2.24 -418 1 16.0917 18.4266 14.1084 2.59329 0.57669 -10.3481 -419 2 15.3502 17.9157 13.7545 1.31994 6.64432 9.22997 -420 2 15.9271 18.7357 15.0116 -3.89333 -11.6647 -1.43214 -421 1 10.0733 4.52495 16.275 12.9842 -2.30982 2.85456 -422 2 11.0043 4.70153 16.4703 -2.64404 5.32532 -3.085 -423 2 10.0864 3.57376 16.1251 -6.72333 -0.470122 -1.54666 -424 1 15.8636 17.8904 4.42819 -6.03116 8.53171 5.31621 -425 2 16.3871 18.7073 4.48664 -0.23776 -8.88425 -2.03055 -426 2 14.9745 18.1441 4.72479 9.46919 -4.85854 1.60726 -427 1 6.9475 17.372 13.7315 15.8768 1.84738 17.2901 -428 2 7.36738 17.5483 14.6019 -4.78498 1.02898 -17.1267 -429 2 7.68915 17.2477 13.1142 -8.54431 1.43966 5.77183 -430 1 13.2923 6.53747 6.71701 -11.5961 -7.93952 14.6915 -431 2 14.1983 6.84596 6.64723 3.17712 4.25021 -11.0614 -432 2 12.8934 6.43009 5.84838 7.58936 1.28323 -8.80485 -433 1 7.69653 2.37351 9.2065 12.517 1.33593 -3.6252 -434 2 7.21057 2.29 10.0355 -5.39375 -0.506169 -1.44147 -435 2 7.12159 2.1318 8.46594 -3.32624 -2.43573 8.05936 -436 1 15.157 14.8759 13.6545 4.5209 -3.06988 2.24561 -437 2 15.0369 15.0852 14.5928 -3.37623 1.75424 -5.30162 -438 2 14.3708 15.1144 13.1546 1.18854 2.2818 3.55032 -439 1 9.31032 8.32311 3.71462 16.317 -0.492826 6.27183 -440 2 10.1522 8.77498 3.89843 -7.06732 -0.949504 -0.86517 -441 2 9.4815 7.39306 3.91425 -6.58464 2.05554 -3.01208 -442 1 17.7054 13.4931 16.4528 -2.79698 17.5255 -9.98682 -443 2 16.7518 13.3863 16.3682 2.15912 -8.30505 3.41837 -444 2 17.8443 14.3312 15.9805 5.97419 -5.13367 5.17943 -445 1 5.02162 10.6562 2.64136 -2.02283 -9.27068 2.47877 -446 2 5.69056 10.1772 3.15718 -2.95942 7.94984 0.663407 -447 2 4.59516 11.2797 3.2389 2.78246 -2.35968 2.10645 -448 1 3.7261 8.35111 10.2906 -2.0647 -5.12326 -12.4171 -449 2 3.87558 9.26669 10.0174 -1.23075 2.88832 6.28188 -450 2 3.61938 8.33938 11.2471 1.47542 3.72119 -0.959794 -451 1 16.077 7.09208 6.26442 0.512876 -15.8531 0.565556 -452 2 16.8498 7.55114 6.61759 -4.58181 2.74438 -1.19615 -453 2 16.2841 6.14901 6.36212 0.103861 8.35624 -6.71996 -454 1 15.1586 7.03156 9.12145 1.35056 8.00181 -20.3615 -455 2 15.9739 7.38238 9.50783 -5.19642 1.69713 -0.962803 -456 2 15.0724 7.48187 8.24992 4.14438 -5.93719 19.2407 -457 1 6.4279 13.1173 12.8809 -5.50985 -11.8139 -9.3985 -458 2 7.12916 12.5687 13.2568 1.68182 7.24531 -2.67671 -459 2 6.29661 13.8986 13.4214 -0.338885 -0.946459 7.65298 -460 1 12.1214 4.48617 13.0834 13.9874 7.50725 -12.3985 -461 2 12.203 4.65044 14.031 -7.85782 -1.77094 2.73271 -462 2 11.2673 4.11709 12.8488 -4.68474 -5.36964 10.3853 -463 1 11.3361 8.19542 7.84742 15.1179 -11.1226 16.1752 -464 2 12.0446 7.62229 7.53485 -1.89389 0.170875 -13.8157 -465 2 11.6069 8.28902 8.77112 -9.48953 8.11742 -0.143346 -466 1 17.184 10.7876 7.43369 13.5323 -0.921102 -17.174 -467 2 17.9233 10.1981 7.20811 -10.1233 -1.22821 11.3165 -468 2 17.1161 11.3267 6.63249 -5.49276 7.55364 9.36769 -469 1 5.23991 18.1348 11.0582 -10.3762 -3.21686 -5.77572 -470 2 4.63631 17.985 11.8048 7.12888 1.45886 -5.61107 -471 2 4.69408 18.0516 10.2533 5.93648 2.65605 9.16476 -472 1 7.56507 17.5919 1.8299 2.38736 9.59194 1.23507 -473 2 7.95273 16.7967 1.45285 -6.05148 -1.8022 -9.76241 -474 2 7.59068 18.2848 1.14776 -2.89899 -11.2976 1.8216 -475 1 1.88529 12.921 13.6059 -1.54804 -3.98178 5.6231 -476 2 1.43748 12.3178 14.2147 5.26513 0.934067 -3.79148 -477 2 2.14524 13.6768 14.146 -0.717118 1.88599 -5.70238 -478 1 9.71545 6.78651 14.8047 -15.2171 15.1422 7.50698 -479 2 9.90531 5.90708 15.1331 4.86835 -12.5985 -3.10865 -480 2 10.0627 6.91606 13.92 3.16992 -4.80507 -4.41639 -481 1 15.2317 4.3547 10.7806 -19.2619 -13.8042 -17.3299 -482 2 16.1692 4.17769 10.7161 9.63774 3.67614 12.8518 -483 2 15.0389 5.06132 11.3962 11.3469 5.0749 6.12787 -484 1 11.2086 6.13697 0.180528 -13.4008 -14.4307 -10.9666 -485 2 11.2654 5.18187 0.0337896 12.1183 5.06406 4.26486 -486 2 10.2799 6.29806 18.6081 2.85376 11.1709 5.84358 -487 1 0.155975 11.3317 15.1259 -12.2739 12.4049 -22.3111 -488 2 18.2869 11.6878 14.3448 9.29886 -6.35489 23.8975 -489 2 18.7388 12.0248 15.8046 -8.78344 -4.02614 -5.34871 -490 1 7.07225 9.17108 7.27057 -4.95781 3.28344 -6.42365 -491 2 6.44778 8.45946 7.46529 5.34767 -0.253084 5.87629 -492 2 7.94637 8.76128 7.25029 -3.14507 0.531691 2.27088 -493 1 18.4147 15.4309 12.3592 -5.86353 -0.606553 -5.09086 -494 2 0.72281 15.5186 12.2612 4.29187 -2.85716 2.67478 -495 2 18.0791 15.7216 11.5043 -3.32345 0.421348 1.66841 -496 1 16.5543 4.36503 5.23509 20.0373 -2.39618 26.5758 -497 2 16.7455 4.21973 6.1845 -16.121 -2.23612 -11.2684 -498 2 17.4558 4.42117 4.89188 -6.1573 5.26009 -14.9538 -499 1 17.766 3.07261 10.7271 -5.62269 10.8805 -1.85707 -500 2 0.0408353 3.2985 10.945 -3.12308 -7.03453 -2.35326 -501 2 17.719 2.23067 10.252 6.41295 1.44898 4.1666 -502 1 12.3026 0.0397215 10.1517 -5.9029 17.7484 6.25384 -503 2 11.458 0.404705 10.4688 2.82225 -9.87605 -6.68676 -504 2 12.8944 0.808865 10.1781 1.22751 -9.09827 -0.112681 -505 1 10.357 9.81077 12.3435 10.1956 0.0137966 -0.104503 -506 2 11.132 9.85287 12.9219 -4.83247 1.57396 1.64677 -507 2 10.2731 8.87192 12.148 -4.78867 -1.2901 1.32484 -508 1 0.505846 2.83821 7.01562 3.91094 -2.13436 13.3247 -509 2 0.681162 3.5182 7.67504 1.89272 4.99945 -7.1411 -510 2 0.694039 2.0503 7.53478 0.801338 -5.04329 -7.26695 -511 1 0.437103 15.2686 6.90942 10.3075 -26.8847 6.28938 -512 2 0.575652 15.2733 7.87231 -4.50905 3.86257 -7.07916 -513 2 0.764375 14.3681 6.66626 -11.1886 22.2654 -1.84191 -514 1 16.9895 7.01682 15.3107 -21.8777 2.45652 -5.46979 -515 2 17.7216 7.6089 15.1142 9.4824 -7.00642 -0.959024 -516 2 17.2645 6.09907 15.4073 14.9833 2.67634 2.96399 -517 1 9.01274 12.4171 8.12853 10.6441 15.1284 15.6095 -518 2 9.41612 11.8292 7.47716 -12.8498 -4.61215 -9.56742 -519 2 8.05003 12.5053 8.0704 6.97129 -9.84551 -10.1137 -520 1 1.26391 1.92336 3.04659 2.32337 -11.3487 -0.982019 -521 2 0.972058 2.42084 2.27545 2.43588 3.35199 3.68236 -522 2 1.90572 2.43981 3.5544 -5.46738 3.49891 -6.33947 -523 1 4.13143 15.1122 9.67174 -10.3949 2.47722 13.8895 -524 2 4.06276 15.2642 8.72313 5.39511 -1.60046 -0.0768584 -525 2 4.99495 14.7433 9.87874 3.88633 -1.07729 -6.21534 -526 1 7.19145 2.18155 14.5787 4.86443 0.520714 0.489557 -527 2 6.89453 1.81445 13.7426 1.87671 -5.23084 1.53267 -528 2 7.73681 2.92919 14.317 0.289792 2.5421 2.67041 -529 1 18.6 14.6947 2.16091 -2.26171 3.41683 0.482467 -530 2 0.820032 15.117 2.19003 5.03273 -5.31768 -1.38278 -531 2 17.9827 15.4314 2.17519 -7.65677 -2.44766 2.74205 -532 1 9.95161 2.77613 12.9401 9.45852 -1.28953 0.462065 -533 2 9.84872 2.18467 12.1812 -5.82301 1.90383 1.05008 -534 2 9.27924 3.46642 12.8986 -6.28602 -3.28272 -2.83121 -535 1 2.83159 8.92314 13.0298 -5.32883 -6.03653 -2.71455 -536 2 3.23927 9.77312 12.842 3.02047 6.8466 -0.359778 -537 2 3.51958 8.34046 13.3637 5.40811 -1.61307 4.23789 -538 1 3.22435 8.37789 3.65229 -1.03338 2.31116 19.4552 -539 2 3.68753 9.01983 3.09696 -0.346577 4.63804 7.35474 -540 2 3.38788 8.57936 4.60408 0.951973 1.27409 -22.7571 -541 1 5.6137 7.19416 8.52025 7.21613 5.80474 -6.44533 -542 2 5.78863 6.24316 8.52523 -9.99458 0.454093 3.85202 -543 2 5.0179 7.43184 9.24037 0.527922 -7.72891 3.36669 -544 1 14.8805 1.29251 2.00129 6.0675 21.6566 -5.88084 -545 2 14.8065 2.10545 2.50153 -6.7285 -1.94379 16.9269 -546 2 15.1655 1.66296 1.16284 -0.437229 -14.9075 -12.229 -547 1 8.26451 15.1933 0.836486 3.22704 -2.0235 12.9462 -548 2 8.92324 15.2163 1.54184 12.9519 -3.35665 -8.03315 -549 2 7.55879 14.6837 1.25205 -6.95241 0.364363 -7.46808 -550 1 15.625 1.34415 7.23495 -17.3283 -0.11068 -5.87671 -551 2 14.9596 0.769214 6.81661 10.6011 2.38946 3.65492 -552 2 15.1493 2.17629 7.38417 4.13791 -2.68619 2.35471 -553 1 4.93041 13.0764 18.5264 9.84655 1.48115 -2.02825 -554 2 5.35318 13.1968 0.744685 -3.49153 -1.64799 -2.34468 -555 2 5.56664 13.4414 17.8965 -2.33559 -1.35641 1.38511 -556 1 15.3557 8.48379 18.1448 0.204246 14.4785 -5.82183 -557 2 15.7265 9.09289 17.4831 -0.830936 -8.68367 1.885 -558 2 15.168 9.07051 0.245745 1.7123 -4.50429 2.39894 -559 1 12.0892 3.02993 18.3645 -15.9576 34.4498 -4.49703 -560 2 11.9769 2.60431 0.571005 13.6468 -16.1673 -1.05926 -561 2 12.5269 2.48004 17.7153 4.47893 -15.6345 5.41851 -562 1 13.2117 12.674 5.1931 -10.339 11.1011 -13.5125 -563 2 13.668 11.9204 4.80624 6.1285 -2.92776 7.79567 -564 2 13.4681 12.7869 6.11335 2.67539 -7.97004 0.458585 -565 1 6.0506 7.06933 0.0406962 1.31452 -3.72946 4.6718 -566 2 6.04306 7.98784 18.9476 0.374235 14.6189 -4.65006 -567 2 5.24553 6.71887 0.435288 -0.866845 -3.58603 0.782556 -568 1 17.739 15.9899 15.0125 -12.5206 6.16285 -12.4036 -569 2 16.945 16.5161 15.03 -7.46495 5.1976 21.0221 -570 2 17.8264 15.955 14.0627 17.7161 -15.0875 -11.5838 -571 1 13.1794 1.00208 16.5735 3.37979 -5.34722 -6.70143 -572 2 14.139 0.860857 16.6169 -5.21536 -1.33728 6.50102 -573 2 12.8035 0.137283 16.3512 2.48828 2.22182 6.02943 -574 1 11.096 14.5828 7.22348 0.0189977 4.74793 7.83345 -575 2 10.4045 14.1614 7.73717 -8.54387 -1.14011 0.371667 -576 2 11.8979 14.1335 7.50232 3.58446 -6.30574 -4.63725 -577 1 17.5104 8.62105 2.08846 14.2737 4.97696 2.51664 -578 2 16.6904 8.42754 2.54903 -5.27316 -4.4343 -3.04137 -579 2 17.6167 7.98338 1.37729 -7.36397 -7.55614 -1.26172 -580 1 12.3515 7.96855 1.99107 6.37927 0.258975 7.77687 -581 2 12.1159 8.90068 1.90258 -3.43959 -5.51169 -5.98444 -582 2 11.9581 7.4701 1.26507 -2.67829 1.90847 0.988543 -583 1 11.8954 14.6159 10.3514 1.85125 4.19108 3.73581 -584 2 12.1615 13.856 9.81631 -7.50724 5.70574 2.33101 -585 2 10.9524 14.815 10.2079 9.27078 -9.38408 -0.682121 -586 1 6.88225 7.03081 15.6002 -4.063 -7.66118 -6.77733 -587 2 7.75096 7.17076 15.1857 -5.63662 2.89282 10.0227 -588 2 6.77779 7.6167 16.36 6.70206 0.515961 -5.66863 -589 1 8.00078 4.70171 13.472 -1.59283 -4.83357 -4.64481 -590 2 7.27623 4.81783 12.8396 5.32657 -1.99722 0.885811 -591 2 8.48998 5.527 13.4768 -0.383179 2.4117 0.469228 -592 1 13.3975 12.1709 14.2706 1.21587 3.44049 5.53322 -593 2 13.2724 11.2098 14.2197 -1.68144 4.93388 -3.39254 -594 2 13.8611 12.4606 13.4725 -0.646036 -5.76058 -0.123004 -595 1 14.8166 9.4384 7.29692 -7.31149 -4.84482 -6.71483 -596 2 15.6063 9.98387 7.39943 -3.2576 1.32409 4.65546 -597 2 14.0612 9.86586 7.70853 4.31514 4.68737 1.52589 -598 1 12.6657 17.0265 3.08863 -0.499632 18.4226 10.5493 -599 2 13.0409 17.4141 3.89779 -4.03665 -9.69042 -5.1428 -600 2 12.0457 17.7132 2.78031 5.51866 -13.6109 -0.0343421 -601 1 1.16791 7.14337 17.4519 -17.3777 -0.471365 -9.17207 -602 2 0.285968 6.88879 17.7816 4.71885 8.57951 0.206219 -603 2 0.996987 7.64547 16.6337 5.09703 -7.79381 5.85561 -604 1 12.7928 5.13809 15.6672 21.9233 -6.79759 1.12632 -605 2 13.5314 4.49934 15.6812 -12.3388 3.06691 0.377185 -606 2 13.2535 5.99313 15.6546 -7.1176 -2.71451 -0.771614 -607 1 2.50804 3.40102 5.01245 -9.19737 1.42964 37.6951 -608 2 1.85734 3.08405 5.69632 14.2768 7.06331 -19.9109 -609 2 3.04485 4.07021 5.49582 -10.9118 -9.07044 -17.2872 -610 1 8.33238 11.2579 13.4651 -31.1482 13.4197 6.60268 -611 2 8.24927 11.0816 14.4232 19.8118 -8.42601 -14.5581 -612 2 9.11403 10.9307 13.0113 5.91799 -11.9552 15.0186 -613 1 12.8978 1.37199 13.3367 -3.68795 11.8567 -21.2004 -614 2 13.3586 1.33808 12.4821 5.12584 -5.42725 10.3839 -615 2 12.3812 2.18266 13.2296 0.582289 -3.8456 10.447 -616 1 6.35916 13.6786 2.13932 11.022 -2.36774 12.7417 -617 2 5.81416 14.065 2.83164 -5.92624 2.48265 -4.44044 -618 2 6.97105 13.1303 2.64934 1.90703 -2.61302 -7.4669 -619 1 15.9256 6.59608 12.7788 -4.50753 -7.00075 -5.11208 -620 2 16.441 7.14613 12.1828 -0.0403293 3.27533 -1.15613 -621 2 16.337 6.66123 13.6439 3.64448 2.92523 3.21919 -622 1 16.8436 0.710185 9.59384 -10.8386 -3.59173 0.641976 -623 2 16.678 18.424 9.8391 7.1202 6.86076 -6.23598 -624 2 16.34 0.863872 8.77611 6.63769 -2.37412 0.960785 -625 1 6.14874 11.7365 8.37914 -9.33508 -33.9533 -7.34454 -626 2 5.23473 11.5355 8.67103 13.3879 7.28881 -1.35634 -627 2 6.50048 10.8558 8.08418 -3.72877 24.3898 8.07481 -628 1 2.86629 8.64627 0.414665 29.1459 -9.93647 1.24251 -629 2 2.37091 8.1673 18.3782 -14.09 11.8062 8.4924 -630 2 2.39345 9.32329 0.907466 -18.2396 -1.77699 -9.50941 -631 1 10.1496 10.4602 6.51654 2.68196 -4.3054 1.18084 -632 2 10.6351 9.79475 7.02051 -3.21697 0.687034 0.899044 -633 2 10.5797 10.4719 5.65285 -1.94715 4.18574 1.72512 -634 1 6.74842 15.6916 6.55665 -2.66838 16.8954 6.36263 -635 2 7.13132 16.1354 7.32023 -0.325366 -7.45035 4.57015 -636 2 6.8063 16.3799 5.88394 5.31174 -8.689 -7.83261 -637 1 6.45137 13.1469 5.60457 -4.49761 -5.86725 0.527716 -638 2 6.60666 13.9979 6.03098 2.95924 -2.27328 1.19215 -639 2 5.97977 12.5923 6.23705 2.74812 2.58161 1.74453 -640 1 16.8067 12.5538 9.81832 0.32671 -4.80998 5.18546 -641 2 16.9975 11.894 9.13199 -1.38663 9.72579 -2.40586 -642 2 16.8023 13.4365 9.43343 1.83869 -5.34542 -5.01893 -643 1 6.05747 2.94525 2.83457 1.69886 0.640591 -2.15275 -644 2 6.28227 3.83854 2.57267 5.15417 9.09864 3.82618 -645 2 5.67557 2.57416 2.03485 -2.61266 -9.3622 -0.552159 -646 1 10.8942 3.30264 3.28891 6.21412 -5.01644 3.41466 -647 2 10.2824 3.98758 3.58006 -2.01501 -0.119341 -5.67488 -648 2 10.543 2.90591 2.48434 -5.60317 1.35459 0.297545 -ITEM: TIMESTEP -30 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.7097 7.05343 17.9609 20.7509 -2.32452 -4.15205 -2 2 7.78893 6.94819 18.1674 -15.0431 -3.26874 3.90688 -3 2 8.91258 6.41114 17.2706 -4.14568 0.140094 0.745653 -4 1 18.6207 8.28878 6.84456 -10.9758 14.7568 -16.4597 -5 2 0.033254 8.12327 5.87995 7.78297 -6.3031 11.7942 -6 2 0.390602 7.58629 7.343 9.14113 -10.4614 1.3502 -7 1 8.4202 18.5906 6.81681 -12.3331 6.77681 2.70587 -8 2 9.32414 0.194792 6.65918 12.4366 2.53215 -2.1327 -9 2 7.89923 0.683074 6.46691 2.1768 -2.64942 -1.08929 -10 1 6.58134 1.82408 11.6823 -18.6778 6.99539 14.5251 -11 2 5.88329 2.28495 12.2086 12.5233 -11.9933 -14.8966 -12 2 6.20729 0.949756 11.4934 -0.484037 1.974 1.03676 -13 1 7.10261 5.71907 2.36398 18.2567 -30.46 4.77574 -14 2 6.748 6.26194 3.05915 -16.1408 13.0855 0.817955 -15 2 6.89353 6.07497 1.50557 -7.56713 14.4666 -6.71064 -16 1 16.2146 10.1912 16.1045 25.8326 -16.9059 -6.28167 -17 2 17.1924 10.2614 15.9892 -26.0275 4.96146 3.01812 -18 2 15.8649 11.0425 16.3511 -1.01593 12.6392 3.03555 -19 1 10.6309 14.9782 2.32852 5.54907 12.6484 -4.66534 -20 2 10.5683 14.607 3.21596 0.623447 -1.40903 0.430751 -21 2 11.0949 15.8303 2.43151 -6.58286 -12.6372 2.6945 -22 1 17.1592 8.25618 10.4876 -10.0218 -2.97818 8.46282 -23 2 16.7485 8.99843 10.9576 2.65758 -6.15573 0.24812 -24 2 17.9939 8.575 10.1448 6.84049 6.50961 -0.847785 -25 1 14.8275 15.8902 16.3678 -10.7483 8.55828 -7.5541 -26 2 13.911 16.2262 16.382 8.40977 -5.5752 2.0788 -27 2 14.9328 15.3229 17.136 -2.68587 0.983086 7.72287 -28 1 12.1445 13.398 0.450021 7.16446 -9.51802 2.88894 -29 2 12.0254 13.4023 18.1304 -4.57533 9.09159 6.34311 -30 2 11.5749 14.0284 0.911779 -3.72154 -0.858053 -5.79964 -31 1 9.27791 5.43254 4.03115 12.5872 2.27984 -15.9713 -32 2 8.88042 5.04351 4.80522 -11.7175 -1.93285 8.71688 -33 2 8.63164 5.36398 3.31053 -0.238489 1.95718 4.1093 -34 1 1.81582 4.23406 11.6392 3.52665 -33.0533 9.77708 -35 2 1.78778 5.15359 11.8657 -3.54286 18.5189 3.84305 -36 2 2.12638 3.75505 12.4373 -4.00166 7.6753 -17.1576 -37 1 1.99877 6.82017 8.35649 4.97761 -1.46296 10.7796 -38 2 2.31944 7.23424 9.17304 -0.0326511 4.09138 -10.3959 -39 2 2.07937 5.88268 8.56766 -7.36821 -1.33929 -3.79841 -40 1 5.395 4.41162 7.94446 4.05063 -3.43427 6.53634 -41 2 5.41133 3.44966 7.94196 6.73946 -4.4132 0.768998 -42 2 4.74595 4.62804 7.28165 -7.35272 12.6119 -8.90882 -43 1 3.28409 2.93052 17.527 4.91883 3.31559 -8.51102 -44 2 3.97895 3.44036 17.0791 -2.08356 -9.03714 -1.68785 -45 2 2.70652 3.59221 17.9099 -2.28402 5.9437 7.00724 -46 1 7.47067 5.28165 6.09824 -7.47353 5.76211 -2.63966 -47 2 7.88561 6.05707 6.46631 15.843 7.70036 2.30241 -48 2 6.86027 5.05727 6.79609 -9.98425 -16.5426 3.24835 -49 1 9.77462 7.02047 11.9927 -3.16333 0.34511 -3.92757 -50 2 10.3836 6.39122 11.588 -5.90607 3.51948 -2.51732 -51 2 9.0529 7.19715 11.3548 12.4276 -3.26368 6.69514 -52 1 14.0466 3.57679 8.07144 18.6703 -0.348541 19.5758 -53 2 13.8937 4.22019 7.39343 -5.64007 13.0869 -9.16622 -54 2 14.611 4.0279 8.7381 -15.3074 -10.3909 -10.441 -55 1 4.67183 17.2138 3.98342 -17.1629 -17.7927 10.2823 -56 2 5.57476 17.4036 4.21567 13.953 12.775 -5.74716 -57 2 4.34342 17.7474 3.25626 2.59666 4.69733 -2.98879 -58 1 16.5112 16.6016 10.1232 -22.4077 14.5184 19.5552 -59 2 15.797 16.9077 10.7255 16.9762 -11.2391 -6.18282 -60 2 16.019 16.127 9.45142 2.29692 -6.2585 -6.10264 -61 1 1.96965 4.87893 0.40906 -10.7697 -8.55226 -4.93465 -62 2 2.66061 5.27529 0.941341 5.5274 3.49831 6.88318 -63 2 1.47511 5.62215 18.6951 6.32177 2.44726 -2.78863 -64 1 11.7331 13.3335 16.3023 -6.06186 -8.167 -3.78825 -65 2 11.2597 12.4992 16.3612 -10.498 -1.32756 10.0093 -66 2 12.2577 13.1697 15.5177 8.21427 7.2284 -4.69488 -67 1 10.121 11.0486 16.9167 -7.88764 10.2638 -1.90592 -68 2 10.5124 10.1783 16.9786 2.49636 -9.86729 -0.127492 -69 2 9.16626 10.9164 16.816 6.71354 -1.99355 -1.80005 -70 1 11.7161 17.4964 13.4564 0.653858 7.10726 11.4031 -71 2 12.4343 17.1488 12.9211 3.60089 1.57548 -4.57497 -72 2 11.8646 18.4589 13.5472 2.97554 -11.89 -7.13537 -73 1 6.3779 9.31416 12.2259 -8.95234 15.1635 22.3379 -74 2 6.77463 8.98312 11.4273 14.2971 -1.19702 -8.86117 -75 2 6.96666 9.97806 12.6372 -2.9053 -11.0825 -10.5803 -76 1 16.2282 12.7644 2.6938 13.255 22.6007 -2.42149 -77 2 17.0484 13.1981 2.39924 -4.54016 -10.6437 3.48813 -78 2 15.6471 13.522 2.85837 -6.5992 -7.46489 -1.32569 -79 1 0.640508 12.5852 5.88727 21.753 -1.83143 4.54161 -80 2 0.997304 12.3975 5.01963 2.04371 1.22983 -7.11515 -81 2 18.3646 12.7399 5.72186 -19.0302 3.73655 0.683884 -82 1 5.21387 16.4194 18.454 4.66732 -1.11443 8.72996 -83 2 5.89359 15.806 18.1817 0.824082 -8.56943 -13.0935 -84 2 5.59435 16.7978 0.603858 -5.48698 7.00748 3.62952 -85 1 0.548987 7.64401 4.10842 0.670348 4.32997 2.73018 -86 2 18.6015 7.92625 3.40384 -3.24873 3.72744 -1.92559 -87 2 1.36738 8.12724 3.94642 3.53853 -5.18785 -2.83474 -88 1 3.12734 8.93117 6.50347 30.4123 1.43415 3.20415 -89 2 3.68489 8.55498 7.21169 -11.4249 4.27745 -10.9708 -90 2 2.23185 8.74841 6.74202 -19.2185 -4.73256 7.28786 -91 1 7.31515 10.3274 16.2171 -7.5998 2.86538 3.08356 -92 2 6.58991 10.5191 15.6248 2.07633 0.375924 -7.53004 -93 2 6.86928 10.3012 17.0718 3.58834 -2.41696 5.50844 -94 1 11.1056 1.03439 5.00906 5.66297 2.87297 -9.25474 -95 2 11.3082 1.81468 4.47889 -2.42802 6.95123 8.17266 -96 2 10.7866 0.43271 4.33294 -5.36858 -10.0003 1.63315 -97 1 4.38851 2.75082 13.2055 -1.16421 16.6802 -23.4007 -98 2 4.78143 3.22961 13.9394 0.315345 -9.27332 13.6616 -99 2 4.20912 1.83275 13.4212 4.21877 -6.70893 11.8835 -100 1 8.39225 10.0828 1.81263 -0.204034 19.0364 -5.60934 -101 2 8.35289 10.7959 2.47026 -1.38438 -3.08289 -2.87504 -102 2 8.81547 9.35618 2.25702 3.41266 -13.1645 6.66357 -103 1 10.4926 1.73671 15.571 11.1439 -7.64614 -12.2914 -104 2 11.3949 1.40928 15.4244 -6.59208 6.73213 11.009 -105 2 10.2461 2.06593 14.699 -6.9068 1.71228 -0.826453 -106 1 2.72763 12.9186 7.78215 1.53907 -1.41162 9.17357 -107 2 3.36352 13.5565 7.43734 -3.21302 -0.65885 -4.12251 -108 2 2.22004 12.5809 7.03913 -2.76352 5.50699 -3.09439 -109 1 3.68558 11.672 5.21041 4.08504 4.36046 -3.38247 -110 2 3.45481 10.9554 5.79468 0.598863 -9.40064 6.30918 -111 2 2.92113 11.7973 4.6466 -2.33635 3.52119 -7.07475 -112 1 6.80415 14.4796 16.8864 5.34146 -11.2852 2.95693 -113 2 7.68462 14.091 16.8709 -3.70601 4.15103 0.993665 -114 2 6.49099 14.4407 15.9783 -2.62919 9.78665 -2.68056 -115 1 14.176 14.5561 3.39307 -12.5209 -3.15767 3.59597 -116 2 13.6245 15.3467 3.3085 5.15733 -4.43597 -5.06132 -117 2 13.635 13.92 3.89178 10.6994 6.10439 -0.0738324 -118 1 8.31018 18.1523 16.0453 25.0942 2.73084 1.98444 -119 2 8.89462 17.4796 16.3723 -6.95894 -25.3404 9.38217 -120 2 8.98968 0.119946 15.7574 -11.3153 21.4924 -7.69748 -121 1 4.73581 1.63729 4.92804 -12.581 -10.4736 11.5054 -122 2 3.83953 1.97889 4.8343 1.42607 1.89675 3.67103 -123 2 5.27039 2.18299 4.37483 11.2234 12.2757 -18.577 -124 1 15.0504 12.7475 16.4383 22.4341 -19.9388 -26.396 -125 2 14.708 13.1949 17.1966 -19.6268 9.49299 12.0559 -126 2 14.4413 12.6723 15.6738 0.429593 5.89098 19.3668 -127 1 15.7794 18.4162 16.8297 -23.8108 0.224717 -24.365 -128 2 16.2557 18.6157 17.6209 13.9809 -1.68 17.1984 -129 2 15.4229 17.5182 16.8969 9.44127 2.10519 2.83182 -130 1 1.1656 1.1613 16.5455 9.88565 -3.33075 -8.05438 -131 2 1.89055 1.78579 16.6066 9.02992 -0.102422 -1.61706 -132 2 0.673214 1.35844 17.3295 -13.4515 3.62078 11.8035 -133 1 18.1028 4.54571 15.8941 -4.73113 6.48399 7.96005 -134 2 18.5013 4.04336 15.196 5.27298 -10.1152 -10.2677 -135 2 18.7433 4.58481 16.606 1.22293 0.259147 -1.01212 -136 1 12.236 16.9836 16.146 14.9412 3.5391 -27.9779 -137 2 11.6416 16.3841 16.5672 -17.548 -8.54782 13.2608 -138 2 12.0887 16.8479 15.1863 -0.907912 9.23395 13.7712 -139 1 15.9498 2.53257 18.0253 10.6473 -13.6828 8.83411 -140 2 15.5627 3.24781 18.526 -5.22656 12.7326 -1.10284 -141 2 15.751 2.68965 17.0989 -3.04742 3.76351 -4.61681 -142 1 6.7038 13.8197 10.2271 2.9338 -17.2727 -3.34939 -143 2 6.61667 13.5512 11.144 -2.24755 5.72821 7.93099 -144 2 6.68776 12.9653 9.76874 -1.43812 10.35 -6.56898 -145 1 10.1318 18.2649 2.7724 -13.411 -9.16786 2.85058 -146 2 10.3828 0.244178 2.09267 2.54842 10.4954 -6.81354 -147 2 9.19143 18.056 2.59362 16.7762 1.59207 3.74676 -148 1 2.99108 17.7409 6.10283 23.0954 -1.76337 16.2177 -149 2 2.19234 17.7622 5.58671 -8.31269 -3.84851 -15.8536 -150 2 3.76803 17.7869 5.51609 -16.1123 2.00349 -4.76697 -151 1 12.5756 16.9274 7.99763 -5.18448 9.92793 0.0594024 -152 2 11.7822 16.4009 7.94219 -1.30832 -15.7704 -9.09049 -153 2 12.3073 17.5896 8.63909 10.7698 6.45321 6.22995 -154 1 14.8838 15.2691 8.24901 11.9288 7.15592 -19.4456 -155 2 14.3219 16.0313 8.11935 -17.9047 1.82161 10.6012 -156 2 15.419 15.3185 7.43747 0.964457 -9.38205 7.76842 -157 1 17.6242 18.2515 0.369787 17.475 26.3316 2.73311 -158 2 18.5101 17.9713 0.0958777 -8.0951 -12.2782 0.813683 -159 2 17.7821 0.518901 0.686034 -9.22006 -13.9572 -3.22273 -160 1 0.867554 10.3913 1.38534 13.3292 31.3771 -20.1166 -161 2 0.0708789 9.90853 1.49908 -23.2341 -17.8443 11.3974 -162 2 0.609768 11.125 0.785047 6.92113 -8.95227 10.8017 -163 1 1.63658 12.2225 3.36866 -7.99561 -17.8946 -31.9552 -164 2 1.35203 11.5128 2.74742 7.334 6.03534 21.6261 -165 2 1.63695 12.9742 2.77054 4.15295 9.67724 10.1418 -166 1 0.571199 17.2371 4.87124 -14.5407 6.59112 32.0774 -167 2 -0.059088 17.9662 4.92138 6.12201 4.50556 -13.0577 -168 2 0.445901 16.8548 5.75927 11.2459 -10.7393 -14.745 -169 1 1.10756 0.954018 9.42478 -6.01064 0.927768 -12.2971 -170 2 1.20282 0.614567 10.324 -1.80966 -3.76099 -1.37067 -171 2 0.239583 0.659806 9.09473 9.24115 0.27684 10.6776 -172 1 16.7657 2.33783 13.2856 -4.77092 -12.7415 18.4331 -173 2 16.9235 2.53629 12.3736 4.43968 6.32108 -18.3535 -174 2 16.5017 1.40258 13.3145 0.84997 6.98888 1.09187 -175 1 2.55595 15.84 12.1915 -9.99296 7.89206 -20.2214 -176 2 3.13585 15.4219 12.8083 9.49953 -6.79049 14.4751 -177 2 2.92245 15.6515 11.3148 -0.922807 -1.51117 1.32599 -178 1 16.4223 15.613 5.98575 -3.71667 -18.1819 11.7841 -179 2 17.3247 15.5921 6.33835 -0.216171 6.69275 -4.6749 -180 2 16.2529 16.4332 5.52058 8.23488 6.69239 -4.77655 -181 1 5.80627 5.05529 11.7835 2.20346 1.03406 8.57972 -182 2 5.47099 5.61389 12.5063 0.21977 1.29573 -10.4635 -183 2 5.43215 4.18052 11.9366 -3.48089 3.11082 -1.53573 -184 1 15.1897 4.8564 0.727292 -5.49239 9.65996 -2.72664 -185 2 15.2051 4.71263 1.67299 -4.1535 -7.09946 8.01526 -186 2 14.3467 5.30742 19.2217 7.5675 -5.77492 -4.69919 -187 1 16.3443 16.3423 2.09898 -10.6702 -0.501744 21.7899 -188 2 16.0343 16.7391 2.94116 7.72577 -10.997 -12.8868 -189 2 16.4832 17.1019 1.54751 7.961 8.6491 -12.4493 -190 1 0.271558 4.86315 3.80356 2.16636 -31.8967 4.70784 -191 2 0.500225 5.77685 3.71679 7.2244 19.9811 4.59738 -192 2 1.02077 4.40389 4.23265 -9.838 12.5034 -4.93629 -193 1 2.94659 15.0442 15.0679 0.642608 -6.50925 -4.27186 -194 2 2.75789 14.5701 15.8868 0.637625 5.4096 6.54553 -195 2 2.48063 15.8876 15.1248 -0.665005 -3.22304 2.52721 -196 1 1.13823 14.625 9.55769 -40.6641 2.98648 23.3687 -197 2 1.89308 14.4183 9.03602 24.2615 -17.8348 -5.78778 -198 2 0.899054 13.8694 10.146 16.149 11.9497 -18.7143 -199 1 13.6328 16.6228 11.5317 -8.77554 -4.828 10.6654 -200 2 13.2136 17.4084 11.1616 -1.58446 0.630618 -8.00902 -201 2 13.0391 15.8864 11.302 7.59245 3.60181 -7.14688 -202 1 4.70114 1.47286 0.734685 -3.14847 1.30924 1.42089 -203 2 4.10181 2.05657 0.255283 4.3012 0.912352 -3.9516 -204 2 4.12143 0.893804 1.23429 -1.01367 -7.44934 0.356301 -205 1 1.44259 18.5254 11.8725 4.87725 -20.5249 2.38925 -206 2 1.2982 0.329643 12.7089 -1.92821 4.76162 2.3937 -207 2 1.66413 17.5975 12.0994 -0.659414 17.7173 -3.45023 -208 1 11.5206 10.1171 4.06393 -3.80452 1.00663 -6.51606 -209 2 11.2843 10.553 3.23019 1.0155 -1.19537 2.23558 -210 2 12.4827 10.1039 4.08159 3.36054 1.41703 2.51077 -211 1 8.33991 12.1729 3.71569 5.40649 2.32091 -9.4304 -212 2 9.08268 12.7024 4.00206 12.7546 1.78956 -5.29094 -213 2 7.80528 12.1916 4.49536 -21.4073 -3.06625 11.8611 -214 1 14.3677 4.01314 3.28101 5.46562 4.88363 2.56432 -215 2 15.0857 4.19963 3.89805 0.543674 -3.28085 4.74869 -216 2 13.622 4.5498 3.58084 0.572713 -1.66955 -3.63784 -217 1 5.59145 1.71061 7.51389 3.0333 8.44076 -17.8773 -218 2 4.93757 1.09228 7.83941 -4.88752 -5.30351 6.58254 -219 2 5.37448 1.80426 6.56172 4.34195 -4.37145 14.4788 -220 1 17.8887 1.09435 4.8754 -0.773263 0.600717 5.02725 -221 2 18.623 1.41887 4.35928 5.70444 0.114988 -11.5441 -222 2 17.8389 1.7231 5.59879 -7.43418 -0.321368 4.00301 -223 1 6.81825 9.41317 4.48156 7.11204 -1.13267 15.9283 -224 2 6.84118 9.52277 5.44603 -5.88151 0.934362 -6.29355 -225 2 7.74851 9.26985 4.27279 -2.06614 -3.64671 -7.13223 -226 1 2.66566 14.925 1.97184 3.43761 -5.8072 22.4208 -227 2 3.31024 14.6851 2.65976 -11.6222 2.95672 -3.26291 -228 2 3.19272 14.9753 1.1906 5.92571 0.162325 -19.2981 -229 1 17.2917 12.9099 13.1468 13.6904 -32.8575 1.82925 -230 2 16.4305 13.254 13.3667 -5.78742 18.0954 -2.54799 -231 2 17.8833 13.5932 12.8229 -8.84805 15.1913 2.15275 -232 1 14.9839 10.5629 1.38454 25.7264 11.2091 10.263 -233 2 15.6084 11.2587 1.71974 -19.4135 -18.6888 -7.72567 -234 2 14.1549 11.0026 1.25075 -10.8149 6.915 -1.22185 -235 1 5.70372 6.84607 4.55662 8.80438 8.80025 -0.823305 -236 2 6.10735 7.7373 4.58073 -7.50282 -10.5851 -1.04914 -237 2 6.32636 6.24858 4.99 1.7616 -0.154003 4.43374 -238 1 8.04871 8.29405 10.2754 3.94684 3.34606 -22.4081 -239 2 8.71637 8.94856 10.0317 -1.03323 4.34225 9.84614 -240 2 7.78699 7.97842 9.39774 -4.16124 -6.72066 12.7971 -241 1 13.4913 18.3469 5.77892 -1.26098 13.9384 -13.7404 -242 2 12.815 0.368504 5.57583 1.14564 -3.93427 -2.76608 -243 2 13.0908 17.8361 6.47463 -1.65231 -11.4802 12.6171 -244 1 0.227007 2.59645 0.141675 -14.0496 12.7254 8.33212 -245 2 17.9751 2.93781 18.665 -4.73692 -13.8452 -6.2234 -246 2 0.694599 3.38298 0.431909 14.3746 0.669884 0.426623 -247 1 12.7219 11.0238 9.75183 49.8657 -12.692 14.413 -248 2 11.8223 11.0616 9.49871 -31.5247 -8.5727 -6.88909 -249 2 12.9406 10.0926 10.0008 -12.7634 16.4478 -4.29644 -250 1 0.765495 12.2256 11.092 -6.27201 -3.92882 -21.6672 -251 2 18.4439 12.3344 11.0429 5.26844 -2.50397 8.5312 -252 2 1.08097 12.384 11.9788 -3.27397 5.59862 9.72518 -253 1 5.06534 7.27352 13.4491 9.82463 3.8805 6.07585 -254 2 5.60445 7.97165 13.048 -4.44492 -2.76176 -4.56894 -255 2 5.50693 7.14172 14.2991 -3.01503 -3.24863 -0.495805 -256 1 1.24722 6.90803 11.85 29.2977 26.916 27.8288 -257 2 0.522094 7.24638 11.3513 -16.2758 4.78156 -11.2742 -258 2 1.67283 7.72942 12.2344 -11.891 -29.9717 -16.3043 -259 1 15.4903 9.51892 12.3126 7.40517 -6.095 -16.4028 -260 2 15.1231 10.4002 12.2744 -2.67202 9.46709 6.64342 -261 2 15.3464 9.12903 13.1709 -3.09066 3.82816 8.99587 -262 1 16.6298 12.8631 5.48891 1.11523 -3.92575 5.75418 -263 2 16.4995 13.8048 5.46845 -2.55881 16.2829 11.3267 -264 2 16.4805 12.6501 4.57692 -1.87933 -15.1854 -15.6508 -265 1 6.21094 9.97472 0.0957231 23.6487 -5.34392 2.82943 -266 2 5.60453 10.4038 0.703481 -3.26342 3.61778 2.3496 -267 2 7.09538 10.0231 0.521798 -18.1891 -1.30215 -0.820391 -268 1 12.348 6.08762 4.05307 2.0614 24.7942 -10.4953 -269 2 12.1492 6.85087 3.46448 11.8353 -14.4305 6.54315 -270 2 11.534 5.60454 4.05688 -13.4451 -11.2489 2.03158 -271 1 0.182227 12.8112 0.197519 7.97213 -0.157956 2.72486 -272 2 0.124577 13.5143 0.856815 -1.71897 -0.134619 0.137441 -273 2 18.3975 13.1734 18.0617 -3.09196 -0.84285 -5.0356 -274 1 3.77998 18.5905 8.57799 -18.8802 5.92516 7.26956 -275 2 3.52251 17.9827 7.88131 5.13558 -0.560148 -6.56591 -276 2 2.92387 0.359522 8.79319 10.0752 -0.462424 4.43469 -277 1 7.44275 17.2901 4.46744 -21.5086 -34.4409 7.51913 -278 2 7.83961 18.0981 4.73248 10.1677 27.4444 -0.194329 -279 2 7.33826 17.2675 3.51576 6.23588 9.30645 -6.08156 -280 1 9.24103 17.0711 12.2479 -19.3743 11.7076 -0.715804 -281 2 9.17102 16.3949 11.5719 7.91635 -8.00505 -0.934966 -282 2 10.0835 16.9964 12.6894 10.2718 -1.4174 0.528472 -283 1 13.295 12.9281 7.96455 10.8524 35.2373 8.53109 -284 2 13.4175 12.2933 8.66577 -5.31299 -13.0614 2.94334 -285 2 13.7676 13.7325 8.27776 -0.249345 -13.5851 -11.5496 -286 1 14.9473 2.96516 15.3472 -8.56764 -6.90335 7.41648 -287 2 14.4704 2.13858 15.1989 -5.86972 7.46703 2.11397 -288 2 15.5773 2.99488 14.6333 9.67131 3.29159 -8.66831 -289 1 9.8733 15.5399 16.9999 -1.15808 -3.26391 2.43146 -290 2 10.4067 14.7753 16.7398 -3.17357 -1.97936 0.56939 -291 2 9.29049 15.2638 17.7267 6.50431 4.19029 -1.43758 -292 1 11.3155 8.30103 16.5489 -8.97523 -12.184 6.64215 -293 2 10.5995 7.86385 16.0596 7.08532 7.34183 -0.412451 -294 2 11.4953 7.67267 17.2664 2.19784 9.25982 -2.90547 -295 1 3.86136 18.202 16.7472 -0.00540616 -19.6914 -20.2162 -296 2 4.27115 17.4628 17.2262 -1.12743 11.6131 4.05136 -297 2 3.85436 0.333712 17.2887 2.36829 10.2975 15.3313 -298 1 2.18996 4.14488 8.93819 0.886129 3.08448 -7.12661 -299 2 3.10445 4.02058 8.72725 13.9566 -1.85365 -12.2229 -300 2 2.19804 3.9794 9.87086 -10.6985 1.40109 20.9797 -301 1 9.87077 10.3617 9.71962 10.1113 -1.13074 11.4426 -302 2 9.57245 11.1887 9.34333 -7.01747 6.00246 -6.1834 -303 2 10.1269 10.5679 10.6319 -2.96085 -6.85282 -1.29137 -304 1 9.72151 0.827202 10.8565 -16.8019 0.79505 -1.6906 -305 2 9.17924 18.7332 11.1654 13.4836 -3.87865 6.80866 -306 2 9.14124 1.21724 10.1941 6.30814 7.82285 -3.72399 -307 1 9.21217 15.15 10.2242 6.46373 1.33184 2.55262 -308 2 8.76537 15.794 9.67699 -2.80645 8.81337 -5.09524 -309 2 8.53339 14.5081 10.4276 -6.91387 -6.36492 -2.48134 -310 1 0.979873 9.39617 10.3168 -32.1534 32.2854 2.26584 -311 2 1.01417 10.3672 10.3328 -11.1793 -7.1298 6.70775 -312 2 1.8685 9.20872 10.1515 40.6499 -19.8378 -9.87175 -313 1 16.9127 4.85919 8.18774 -4.59801 12.0977 -12.3954 -314 2 16.2737 5.53573 8.4435 0.928859 1.2732 2.05393 -315 2 16.9639 4.27263 8.93179 4.52425 -11.0836 8.47724 -316 1 14.6737 14.709 0.318185 15.3338 2.15239 -13.9805 -317 2 15.2295 14.9726 1.0606 -1.701 5.56475 -1.20644 -318 2 13.8551 14.4222 0.702232 -12.5496 -7.63291 5.74768 -319 1 3.57822 11.0521 9.58832 7.05767 -0.848593 3.86503 -320 2 3.70772 11.5491 10.4084 -2.82358 -5.49605 1.13538 -321 2 3.0796 11.6369 9.01245 -0.492053 5.16034 -4.32733 -322 1 11.1043 10.8166 1.33994 -11.5702 -13.9866 8.70354 -323 2 11.3928 11.6085 0.903197 7.06397 14.5046 -5.44138 -324 2 10.1649 10.7312 1.10986 7.36828 -2.13735 3.91294 -325 1 13.1846 7.09882 12.8318 18.6724 6.28095 -0.937746 -326 2 14.1536 6.98642 12.9472 -16.4658 1.64828 -3.93553 -327 2 12.8311 6.20921 12.7949 -4.05904 -6.33012 1.01947 -328 1 9.62724 1.89857 0.976269 -5.84048 -4.71512 -19.854 -329 2 8.85605 1.47112 0.556627 5.981 10.7585 7.84687 -330 2 10.1714 2.22507 0.238723 -1.51496 -2.73206 9.47681 -331 1 10.5937 13.5214 4.66199 3.2234 0.0339744 -7.62843 -332 2 11.4486 13.114 4.51461 3.39436 -8.72009 -0.849353 -333 2 10.7191 13.8974 5.52846 -5.55452 9.94363 9.85641 -334 1 14.3279 1.73837 10.9221 -6.80645 -20.6925 1.76137 -335 2 15.1234 1.41881 10.4767 1.97621 6.90305 1.731 -336 2 14.3743 2.69243 10.9875 9.24527 6.91542 -4.56959 -337 1 14.6348 12.3447 11.7069 0.143663 -8.85162 -7.69369 -338 2 15.3924 12.4169 11.1267 15.8185 6.23005 6.53749 -339 2 13.9779 12.0599 11.0796 -19.2308 -4.32411 1.56042 -340 1 8.24345 5.06862 9.81236 -2.43519 -19.796 -15.4196 -341 2 7.42328 5.28077 10.2334 -12.2119 11.2175 13.6651 -342 2 8.03366 4.19231 9.43495 14.0834 8.03075 2.78805 -343 1 1.55958 16.8456 18.3509 0.293915 -24.903 24.1992 -344 2 1.74487 17.2231 17.5072 8.4457 6.47265 -18.7434 -345 2 1.95964 15.9468 18.3277 -12.6492 15.8955 -3.16542 -346 1 1.46885 17.2295 15.3261 -41.9231 18.9429 7.61422 -347 2 1.60163 18.0716 15.7975 2.88525 -7.29411 -7.90761 -348 2 0.471438 17.1304 15.2829 39.2238 -5.53287 -0.382895 -349 1 3.69895 5.65007 6.13962 5.67498 -13.7905 -4.71311 -350 2 3.08621 6.15365 6.67268 -1.79156 10.6243 5.04455 -351 2 4.29662 6.26435 5.6935 -4.62364 1.91275 -0.121461 -352 1 12.3686 9.4572 14.1916 2.50325 4.1373 0.835901 -353 2 12.6534 8.64397 13.7789 7.43403 -8.19142 -7.10693 -354 2 12.2431 9.18714 15.1032 -3.68368 1.41273 6.14038 -355 1 4.03462 15.2828 6.91278 -20.0144 -6.90546 3.84648 -356 2 3.57361 16.022 6.48562 4.0204 -1.30953 4.99773 -357 2 4.97214 15.427 6.85986 17.0804 8.85667 -5.89205 -358 1 0.596937 8.57007 14.913 -2.82207 -2.34568 11.0967 -359 2 0.589839 9.51288 15.1099 0.171131 2.88226 -3.41975 -360 2 1.22453 8.45469 14.2015 6.96836 3.95738 -3.73783 -361 1 12.9772 8.31295 10.3135 -4.52981 3.4147 9.81026 -362 2 13.748 7.88649 9.95158 7.10588 -4.96512 -13.4998 -363 2 13.0418 8.05063 11.2408 -7.87478 3.04011 -0.538852 -364 1 15.3081 7.67138 3.5266 23.4653 37.2808 -10.5735 -365 2 14.5495 7.31548 3.08478 -13.5361 -20.5278 3.76808 -366 2 15.7097 7.21489 4.26906 -13.5998 -13.5183 6.32814 -367 1 17.3139 6.67347 0.0519528 8.75828 -11.5188 0.32751 -368 2 16.922 5.81479 0.236083 -1.36263 0.235584 3.31968 -369 2 16.5542 7.20912 18.4844 -8.7655 12.4237 -8.09845 -370 1 8.86065 6.91878 7.81669 10.1209 17.2302 -14.0365 -371 2 9.80786 7.17641 7.77744 -16.0922 -4.42618 4.57681 -372 2 8.74795 6.24147 8.48473 3.77983 -6.9476 8.96536 -373 1 12.3541 0.627989 1.20673 7.59332 -4.64776 2.86492 -374 2 13.2579 0.528374 1.53727 -3.51801 6.0046 2.76074 -375 2 12.2851 18.632 0.498856 -2.53947 0.382583 -4.14536 -376 1 5.64549 15.138 14.5235 -4.10456 -30.421 5.78959 -377 2 4.73353 15.1769 14.8501 2.72532 6.49481 -6.12593 -378 2 5.9656 16.0086 14.3294 1.76375 18.5631 -6.42604 -379 1 3.85619 6.49135 1.72458 1.34418 -5.76632 6.1851 -380 2 3.4082 7.28863 1.44351 -4.61345 8.91678 -8.73454 -381 2 4.04036 6.67595 2.65567 -1.04596 -4.79787 -3.17499 -382 1 3.88128 11.6181 12.3021 -8.90147 -4.54474 -0.675722 -383 2 4.76839 11.88 12.5585 3.1774 6.51538 0.922611 -384 2 3.25574 12.2257 12.7332 9.80963 -6.2977 -1.14662 -385 1 5.41097 3.86243 15.8619 7.77498 -26.7447 2.47729 -386 2 6.19051 3.2555 15.8125 -22.34 13.8462 -4.82428 -387 2 5.75732 4.74289 15.8731 9.06733 16.771 0.375084 -388 1 14.4275 10.3077 4.42737 -15.4583 -1.2468 24.8449 -389 2 14.4136 9.7945 5.25584 5.65105 6.60384 -6.24763 -390 2 14.7139 9.69599 3.76155 7.16087 -8.52398 -12.4829 -391 1 7.87022 17.3652 9.18307 -6.55512 0.129027 -0.760847 -392 2 7.04604 17.5698 9.62158 -5.94597 -4.85201 9.5143 -393 2 7.92762 18.0395 8.50377 8.60962 -1.46955 -8.60251 -394 1 4.50919 14.4633 3.94747 -3.26277 6.69504 -13.1744 -395 2 4.44326 15.3745 4.23469 1.61374 7.68172 -2.63862 -396 2 4.73121 13.9745 4.72809 3.38773 -13.7326 11.5154 -397 1 14.2916 7.39166 15.7799 -19.0102 -0.643935 -4.97281 -398 2 15.227 7.28492 15.6956 21.3172 -2.59108 -3.06 -399 2 14.1661 7.73476 16.6606 0.966931 5.43289 9.36717 -400 1 2.93597 18.2496 1.90178 2.72474 -19.4407 -7.90163 -401 2 2.41137 17.5137 1.50762 13.3283 19.165 4.04527 -402 2 2.31568 18.912 2.18531 -12.4791 7.28301 8.56329 -403 1 7.97625 1.60842 4.55987 -20.0747 11.2227 -5.58284 -404 2 7.40672 2.18903 4.02942 -3.00667 -10.939 3.58357 -405 2 8.83426 1.86357 4.26417 23.6954 -1.42515 0.234182 -406 1 2.55973 14.139 17.7235 4.4947 4.4122 -3.81652 -407 2 1.9869 13.4419 18.0532 -4.8721 0.171095 2.94118 -408 2 3.45785 13.8729 17.9629 -0.333069 -3.9381 0.822902 -409 1 0.778432 1.72633 13.8806 -27.0748 -1.51039 10.7449 -410 2 0.840363 1.33642 14.7677 3.59517 6.80992 -7.55552 -411 2 18.4512 1.86919 13.7675 25.1129 -0.50251 -4.23703 -412 1 4.5218 18.6217 13.9311 -26.2208 4.76485 6.31935 -413 2 5.44026 18.4597 14.0857 18.6112 -6.32709 -3.49173 -414 2 4.08533 18.4032 14.7706 3.39103 3.57256 -5.13956 -415 1 7.0966 0.590139 18.3583 40.0867 -7.03194 -16.485 -416 2 7.43029 0.218977 17.5038 -14.1267 7.45313 19.238 -417 2 6.15491 0.497007 18.3797 -17.6926 4.43938 -0.268226 -418 1 16.0869 18.4184 14.0665 12.1783 12.0602 19.9903 -419 2 15.2602 18.093 13.7757 -22.8702 -12.1677 -15.3509 -420 2 15.9307 18.6351 14.9998 9.22594 -1.26981 -3.76068 -421 1 10.0615 4.5254 16.2644 17.4965 34.4304 -0.599412 -422 2 10.952 4.96419 16.2693 -15.2122 -21.3498 0.578373 -423 2 10.2001 3.58581 16.3272 5.99955 -12.591 -1.94777 -424 1 15.8874 17.8488 4.44366 26.9944 -8.8935 -8.85545 -425 2 16.3583 18.6921 4.41154 0.375294 -2.3726 2.41747 -426 2 14.9936 18.0388 4.65191 -27.7242 10.9512 11.1951 -427 1 6.97313 17.3837 13.7492 -14.8371 0.980348 6.17816 -428 2 7.33935 17.5289 14.6184 6.46616 5.40365 9.01508 -429 2 7.73032 17.2786 13.1826 8.79779 -2.98362 -9.94394 -430 1 13.295 6.50203 6.69495 9.53809 17.2257 -14.0038 -431 2 14.0496 7.07319 6.46986 -0.499105 -8.31015 13.7378 -432 2 12.8724 6.42857 5.83749 -8.85952 -9.05901 -3.70628 -433 1 7.73318 2.36184 9.23357 -5.82839 -0.191385 25.6357 -434 2 7.13515 2.2598 10.0003 13.8878 3.27143 -3.38814 -435 2 7.19146 2.08044 8.50905 -8.01798 -3.82737 -18.8349 -436 1 15.1683 14.8678 13.6621 4.32457 -5.24538 6.92634 -437 2 15.0117 15.191 14.5524 1.96766 -1.10504 5.54809 -438 2 14.4461 15.1877 13.1369 -6.78809 4.58671 -11.3713 -439 1 9.33811 8.31525 3.72912 -3.71623 14.6513 -1.76526 -440 2 10.1422 8.72537 4.07444 1.32163 -4.04075 -0.39549 -441 2 9.3744 7.3721 3.88081 4.66337 -7.69389 3.46587 -442 1 17.73 13.5264 16.4473 3.62887 -10.5665 6.33517 -443 2 16.8053 13.2497 16.375 1.67263 6.91521 -3.1024 -444 2 17.8249 14.3621 15.9879 -5.28625 7.64018 -4.86126 -445 1 4.99014 10.6392 2.69296 -11.8842 10.0017 7.67541 -446 2 5.62836 10.2105 3.25699 12.1385 -6.17254 3.53336 -447 2 4.64978 11.3543 3.2597 0.304061 -9.29163 -9.90123 -448 1 3.7356 8.34279 10.2382 -0.81373 18.9096 -12.0232 -449 2 3.86658 9.26506 9.94102 0.197912 -10.4595 0.115104 -450 2 3.49052 8.44407 11.1547 0.601112 -5.92985 11.4704 -451 1 16.0428 7.05286 6.2029 -10.6575 13.2953 -5.82849 -452 2 16.855 7.48535 6.46978 4.82485 2.35526 4.73173 -453 2 16.1613 6.12013 6.32007 7.39497 -13.7867 -3.51418 -454 1 15.1327 7.05037 9.11575 3.87713 -5.32828 6.40762 -455 2 15.8626 7.43029 9.61535 2.26476 1.25298 1.00848 -456 2 15.1324 7.53151 8.29313 -1.46271 6.60183 -11.5025 -457 1 6.39444 13.0666 12.8402 5.00849 -18.9174 -4.31708 -458 2 7.14138 12.6166 13.2588 -1.3728 0.0732389 -8.28768 -459 2 6.25233 13.8543 13.3456 -7.70591 16.466 12.3405 -460 1 12.1285 4.48598 13.0882 -38.1563 -9.245 -8.92104 -461 2 12.05 4.67155 14.023 12.2106 4.08095 10.8898 -462 2 11.2367 4.10453 12.8753 29.4794 5.44987 -0.890783 -463 1 11.348 8.18475 7.8598 -17.4059 7.12531 -10.6431 -464 2 12.038 7.63484 7.48501 10.4081 -6.60064 5.31237 -465 2 11.4756 8.28116 8.80352 11.9689 -3.04214 7.26146 -466 1 17.1922 10.8074 7.44155 -25.4203 14.6985 18.6261 -467 2 17.9197 10.2075 7.32737 10.9985 -8.38668 -11.5183 -468 2 17.0629 11.3797 6.67504 9.09121 -1.65978 -2.87918 -469 1 5.25169 18.1248 11.0507 12.0648 3.50666 -3.83562 -470 2 4.62743 17.897 11.7414 -1.9785 0.423337 4.7613 -471 2 4.73712 18.33 10.2687 -7.94827 -3.02158 -5.48025 -472 1 7.57794 17.5568 1.83513 6.93874 5.3114 -35.8297 -473 2 7.86736 16.7596 1.34843 -3.99011 9.3379 11.9664 -474 2 7.57256 18.2518 1.1344 -7.92946 -12.1924 16.8763 -475 1 1.91036 12.9101 13.6013 -3.96045 -14.8375 -19.2024 -476 2 1.39392 12.2568 14.0828 0.939403 1.79227 7.54842 -477 2 2.06766 13.6568 14.1634 3.48639 14.3121 10.7878 -478 1 9.68075 6.78169 14.8149 2.18853 -17.0585 -1.56943 -479 2 9.86519 5.84438 15.0146 -5.66436 10.7434 4.7021 -480 2 10.1054 6.93436 13.9655 -4.91522 4.89205 -3.51643 -481 1 15.2489 4.31705 10.7696 10.3165 19.1063 17.7081 -482 2 16.2033 4.28261 10.8841 1.13215 -16.3849 -6.84609 -483 2 15.045 4.99149 11.4324 -10.9146 -3.35461 -8.40134 -484 1 11.2157 6.13912 0.184288 19.0347 18.6277 4.4365 -485 2 11.389 5.28379 -0.213728 -9.30505 -7.86745 -0.661886 -486 2 10.2971 6.41228 18.7766 -10.0409 -9.92482 -6.17869 -487 1 0.119384 11.3453 15.1007 -14.3711 11.1071 -8.9459 -488 2 18.1083 11.5338 14.3994 8.87914 -3.31428 2.86805 -489 2 18.675 12.1405 15.6491 -0.376992 -6.76779 4.41889 -490 1 7.06293 9.20482 7.26347 16.9728 2.93661 -2.33726 -491 2 6.45996 8.52415 7.5376 -12.746 -11.932 7.1182 -492 2 7.92776 8.76781 7.32981 -4.82181 7.51802 -3.03552 -493 1 18.3776 15.4097 12.3582 -11.3114 -7.16639 4.00893 -494 2 0.682756 15.4096 12.2525 13.0982 4.14044 -6.05458 -495 2 17.9899 15.7976 11.566 2.11158 0.973908 -1.02825 -496 1 16.5513 4.36706 5.24159 -5.09045 5.24791 -23.7034 -497 2 16.6166 4.33687 6.19466 14.1446 -5.59224 10.5876 -498 2 17.404 4.59908 4.81371 -8.86364 -4.80736 14.9956 -499 1 17.7417 3.09647 10.7341 0.291254 -10.6186 -10.4582 -500 2 0.00513181 3.34109 10.9087 8.18655 7.52385 6.55564 -501 2 17.8253 2.23203 10.2933 -8.67083 8.1401 4.47273 -502 1 12.2919 0.0227122 10.1361 2.29147 -28.3523 -7.04943 -503 2 11.4789 0.3695 10.4906 -11.5623 8.87459 2.77288 -504 2 12.9485 0.705533 10.1424 9.22066 20.6222 4.35768 -505 1 10.3653 9.79669 12.372 -8.95345 -3.20907 -9.5203 -506 2 11.0695 9.83133 13.0162 9.21286 -1.60231 7.36796 -507 2 10.2442 8.85709 12.1552 0.446892 6.98856 4.38647 -508 1 0.537603 2.83987 7.02256 -3.09155 -21.8169 -17.6677 -509 2 0.689112 3.48917 7.69969 6.81735 5.32415 12.4887 -510 2 0.745143 1.97019 7.39814 0.967775 11.9311 3.78775 -511 1 0.407687 15.2844 6.91114 -10.1505 12.0239 22.1786 -512 2 0.487576 14.9005 7.81264 0.770838 8.15944 -16.8401 -513 2 0.754028 14.6482 6.29753 4.41733 -17.9374 -4.37366 -514 1 17.0108 7.01877 15.2726 9.75856 -4.98107 -8.16179 -515 2 17.7945 7.53845 15.0774 -4.62906 13.8031 -0.900924 -516 2 17.4019 6.14594 15.3485 -8.43732 -9.20439 7.91006 -517 1 9.04118 12.4266 8.12126 20.8625 -13.8276 -21.4288 -518 2 9.31201 11.8186 7.41014 14.8696 5.22508 9.07579 -519 2 8.11227 12.3461 8.03152 -32.7632 10.2849 9.08461 -520 1 1.26557 1.8876 3.02782 9.65045 8.01813 1.36118 -521 2 0.751817 2.27104 2.32199 -7.08934 -1.28284 -8.05339 -522 2 1.78864 2.63408 3.35807 -1.4257 -10.3882 4.86199 -523 1 4.12138 15.1091 9.73113 11.5132 -2.98862 0.0844269 -524 2 4.08037 15.3711 8.80771 -6.64563 1.38763 -1.25331 -525 2 5.02377 14.7713 9.82789 -5.61093 0.302526 6.22582 -526 1 7.21558 2.18454 14.596 -3.30246 -13.7461 5.2135 -527 2 6.95017 1.78255 13.7582 4.82488 2.3919 4.06302 -528 2 7.77929 2.92256 14.3836 3.82883 9.51482 -6.38734 -529 1 18.5827 14.6796 2.1698 -24.3208 -2.36026 -2.50397 -530 2 0.827663 15.0286 2.10654 6.16868 9.29818 1.18622 -531 2 17.9285 15.4101 2.10387 15.0339 -9.50868 3.05979 -532 1 9.96457 2.76705 12.9307 -6.0306 9.60441 -0.715471 -533 2 9.81933 2.16697 12.1996 2.81266 -10.505 -5.71659 -534 2 9.23975 3.40361 12.8511 1.73763 -0.77134 6.44595 -535 1 2.86173 8.92609 13.0404 7.24036 -2.57601 -2.21085 -536 2 3.32754 9.76259 12.8684 -5.41233 -1.95407 1.34833 -537 2 3.53569 8.30272 13.3558 -0.616664 3.71534 -0.977901 -538 1 3.21505 8.40688 3.66968 15.7234 22.1036 -19.602 -539 2 3.76887 9.07341 3.20135 -16.7118 -11.852 2.14794 -540 2 3.39007 8.60458 4.57891 -0.363765 -1.98929 20.9454 -541 1 5.60252 7.19004 8.53175 5.86958 -4.86959 9.5617 -542 2 5.84506 6.27445 8.70563 -2.01066 -2.63063 -12.6146 -543 2 5.1548 7.42343 9.34691 -7.32508 9.6882 0.185442 -544 1 14.8904 1.34267 1.9851 -2.44355 -11.2972 17.4528 -545 2 14.6303 2.11535 2.51846 2.91157 0.487188 -15.3266 -546 2 15.025 1.53806 1.05778 2.17575 14.4946 -4.76666 -547 1 8.30348 15.1948 0.839181 1.62975 3.11742 -15.2912 -548 2 9.05101 15.1086 1.44328 -1.42893 -5.28711 5.64984 -549 2 7.54504 14.6965 1.17349 5.50357 -4.17517 7.24781 -550 1 15.6062 1.34647 7.22998 12.9139 6.24135 5.03718 -551 2 15.0343 0.764422 6.7383 -10.7397 -5.17 -5.22658 -552 2 15.1371 2.18077 7.35367 -5.42005 -2.19365 2.65732 -553 1 4.96367 13.0608 18.5175 -8.25637 -3.65043 -17.7207 -554 2 5.34878 13.2483 0.722802 8.16177 0.261597 12.4464 -555 2 5.65153 13.2431 17.8644 -2.22894 4.298 3.81358 -556 1 15.3614 8.50445 18.1376 -9.02232 -8.38547 12.9254 -557 2 15.7319 9.00583 17.4156 5.20151 10.9324 -8.24127 -558 2 15.1687 9.14311 0.198883 4.58141 -1.82544 -4.44514 -559 1 12.0904 3.05083 18.3558 5.74067 -18.2993 3.78166 -560 2 12.2947 2.48128 0.458355 -7.48955 9.04159 13.408 -561 2 12.4465 2.47277 17.6781 -3.43414 10.0689 -17.6065 -562 1 13.2065 12.6801 5.18634 5.84251 -1.21193 6.01102 -563 2 13.6832 11.8727 4.98831 0.374712 -2.89081 -11.6293 -564 2 13.5252 12.8732 6.07674 -9.12379 3.52213 -1.02632 -565 1 6.05538 7.10808 0.0622478 7.64822 4.54905 2.96407 -566 2 5.99209 8.01824 19.0386 -2.92171 -4.08442 -8.95141 -567 2 5.21644 6.68693 0.272307 -1.20959 2.69213 5.93171 -568 1 17.7218 15.9656 14.99 27.5308 -15.6865 18.0891 -569 2 16.9388 16.4863 15.1181 -14.3434 5.91292 -14.0866 -570 2 17.911 15.7342 14.0701 -14.8265 10.2647 -3.26624 -571 1 13.1712 0.994875 16.5867 2.52549 -1.56274 -3.32645 -572 2 14.0875 0.750433 16.7652 2.07951 0.899412 2.60052 -573 2 12.7522 0.177983 16.2988 -0.931869 -3.47373 4.92885 -574 1 11.0723 14.6005 7.26575 -13.1255 -10.0571 4.65979 -575 2 10.3507 14.0428 7.62559 10.576 8.81418 -2.61622 -576 2 11.902 14.168 7.50495 -4.44994 -4.81764 -1.49609 -577 1 17.5239 8.59779 2.09084 -4.28833 -20.5194 -15.9758 -578 2 16.6824 8.33187 2.48237 1.37862 7.81735 4.46419 -579 2 17.5834 7.99355 1.32242 5.93631 9.11716 13.4418 -580 1 12.3581 7.93946 1.97566 -1.89696 -6.27914 -3.50436 -581 2 11.9505 8.79823 2.04436 -0.86405 10.6038 1.69948 -582 2 11.9097 7.53044 1.22383 5.98844 -6.29912 5.7943 -583 1 11.9176 14.6241 10.3724 -2.87076 17.8373 18.3305 -584 2 12.1889 13.9308 9.80998 14.0474 -22.5763 -16.4958 -585 2 11.017 14.792 10.1004 -10.4734 4.60408 5.02203 -586 1 6.86179 7.0045 15.5825 0.298402 -7.5032 -11.9192 -587 2 7.72978 7.09161 15.1865 4.58892 -5.83629 -5.839 -588 2 6.8806 7.68521 16.2363 -7.39186 11.3873 16.6815 -589 1 8.0061 4.66768 13.4643 -26.1906 -20.4665 -29.1007 -590 2 7.40104 4.82554 12.6933 13.2028 -5.13213 23.0799 -591 2 8.47723 5.469 13.5831 13.4856 24.6751 2.60837 -592 1 13.392 12.1682 14.29 6.21681 3.24263 -1.56593 -593 2 13.3744 11.2127 14.1772 -7.69192 -2.80185 3.02585 -594 2 13.9051 12.489 13.5384 -1.40129 2.2659 -1.62493 -595 1 14.7806 9.45441 7.28093 -11.5532 20.7697 15.955 -596 2 15.4984 10.0862 7.4818 -3.61589 -14.7511 -6.73617 -597 2 14.0294 9.75726 7.82532 9.94729 -6.45384 -10.5104 -598 1 12.6903 16.9959 3.11063 13.9021 -20.0527 -1.11079 -599 2 13.0479 17.2495 3.95961 -1.86196 6.25123 9.18833 -600 2 12.0243 17.6278 2.88206 -13.6174 14.7021 -2.85583 -601 1 1.14933 7.13689 17.4392 -10.8552 -5.82346 1.42608 -602 2 0.254324 6.85235 17.6903 1.68989 10.0465 1.1249 -603 2 1.04814 7.64429 16.6282 0.816381 -0.80389 -4.56811 -604 1 12.8311 5.11146 15.6849 -17.6595 -4.33947 -1.38663 -605 2 13.5036 4.46543 15.459 7.94947 -3.95791 3.77703 -606 2 13.2565 5.97185 15.6774 7.16 2.75079 -1.64654 -607 1 2.47852 3.39671 5.05511 -15.8601 -20.9034 -7.20071 -608 2 1.89248 3.0773 5.76599 4.829 7.89548 -3.4806 -609 2 3.06433 4.04634 5.42706 4.34046 14.9349 7.02505 -610 1 8.31182 11.2281 13.4853 12.2486 -8.92827 -7.03776 -611 2 8.34382 10.988 14.3869 -16.2376 0.866389 37.005 -612 2 9.12412 10.7865 13.2309 -0.249665 2.67206 -26.3927 -613 1 12.9087 1.417 13.3166 0.0274524 -25.355 19.3096 -614 2 13.4801 1.21198 12.5759 3.32243 8.60198 -10.444 -615 2 12.4274 2.20637 13.1188 -4.80778 18.3372 -7.59901 -616 1 6.3961 13.6531 2.14242 21.3539 -7.72513 -19.5528 -617 2 5.86296 14.1246 2.76583 -10.9825 4.85946 19.6126 -618 2 7.0399 13.1177 2.63436 -6.77103 3.35988 1.82582 -619 1 15.9312 6.57282 12.7577 9.39393 9.94387 -6.4398 -620 2 16.4454 7.11896 12.1297 -10.141 -7.43973 7.84454 -621 2 16.2972 6.7745 13.6327 -0.398164 -4.05689 -3.4507 -622 1 16.8338 0.714138 9.59622 -4.58014 7.56344 -3.36861 -623 2 16.786 18.4184 9.78234 2.45796 -8.84878 0.088887 -624 2 16.3762 0.83732 8.75167 2.21028 0.792186 -0.559114 -625 1 6.14371 11.7069 8.36929 2.81279 3.26044 -4.5559 -626 2 5.21452 11.6136 8.62066 2.93526 -5.28935 1.80511 -627 2 6.46143 10.8412 8.07651 -3.38714 0.356066 2.25694 -628 1 2.85881 8.67012 0.388915 2.79689 11.0982 14.7719 -629 2 2.20875 8.30366 18.4701 -9.93413 -28.5632 -26.9968 -630 2 2.30006 9.32334 0.801848 8.26615 13.7996 15.8107 -631 1 10.1321 10.4555 6.53489 -7.45039 0.329373 10.0784 -632 2 10.6046 9.83719 7.10845 -0.190248 -0.487921 -4.0191 -633 2 10.6634 10.5725 5.74842 5.176 -1.34798 -7.09506 -634 1 6.75471 15.7115 6.57125 -11.9312 -6.35937 -2.57899 -635 2 7.17812 16.0056 7.37746 4.55156 8.98271 2.0062 -636 2 6.84858 16.4009 5.89838 10.4548 -3.40393 4.92981 -637 1 6.44667 13.1112 5.62964 2.65073 6.32881 3.74437 -638 2 6.67596 13.9769 6.00675 -0.0120675 -6.80172 -3.34498 -639 2 5.96115 12.6448 6.31389 0.45756 -2.92263 2.45964 -640 1 16.7937 12.5442 9.80018 5.98989 11.7335 -8.95445 -641 2 16.9887 11.9765 9.05284 -0.702856 -11.4944 -2.64553 -642 2 17.0098 13.4184 9.45025 -4.64512 -2.35242 9.41775 -643 1 6.08081 2.94855 2.81201 5.81343 6.87552 13.2918 -644 2 6.21399 3.88965 2.59312 -1.02666 -12.0092 -4.68113 -645 2 5.77459 2.45978 2.03916 -1.91968 5.61369 -5.09877 -646 1 10.8797 3.26448 3.27711 -5.41025 -2.45564 -6.20574 -647 2 10.301 3.99846 3.49319 -0.0844139 2.78359 4.78679 -648 2 10.5123 2.93026 2.45079 3.61554 -5.12824 0.569032 -ITEM: TIMESTEP -40 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.73557 7.01799 17.9607 21.964 -6.69295 -3.41675 -2 2 7.837 6.97936 18.244 -22.923 1.28376 8.03757 -3 2 8.84363 6.25859 17.3828 1.27689 0.0651665 -4.69765 -4 1 18.6647 8.30209 6.83035 -0.644058 3.99523 -48.5507 -5 2 0.211245 8.12789 5.86514 -9.60619 8.91963 25.083 -6 2 0.465598 7.58914 7.26037 9.90688 -14.2806 22.1152 -7 1 8.44495 18.6364 6.8238 -19.0399 -0.344231 6.51496 -8 2 9.34052 0.200584 6.61788 21.6732 5.78047 -4.99449 -9 2 7.92466 0.711623 6.44684 1.16681 0.183702 -1.11302 -10 1 6.56005 1.80411 11.6838 -38.7214 4.43655 14.793 -11 2 5.75321 2.272 12.0538 30.5925 -16.6996 -9.96133 -12 2 6.22943 0.898268 11.5156 6.32845 11.0599 0.0206858 -13 1 7.08366 5.68816 2.38617 22.7225 -30.9477 -12.475 -14 2 6.58152 6.21056 2.95839 -27.8787 23.1579 37.4024 -15 2 6.84697 6.04683 1.54845 0.038941 9.08719 -25.9535 -16 1 16.22 10.2137 16.0864 41.4588 -5.13522 6.23048 -17 2 17.1921 10.3703 16.208 -28.8473 -8.8876 -9.54756 -18 2 15.8271 11.0171 16.4051 -13.971 12.6367 2.51598 -19 1 10.6448 14.9575 2.33364 6.27542 19.2207 -0.856148 -20 2 10.5562 14.6084 3.22703 2.40752 -4.54155 -3.02292 -21 2 11.1101 15.8129 2.46012 -8.85901 -18.4002 -3.84051 -22 1 17.1611 8.2532 10.553 -11.2529 -0.0170881 12.6501 -23 2 16.8393 8.94572 11.1538 -1.12797 -5.57792 -5.31501 -24 2 17.9446 8.61302 10.1436 10.8511 4.56282 -2.94704 -25 1 14.7728 15.897 16.3892 -19.7826 14.9663 0.46496 -26 2 13.8411 16.2137 16.4626 21.4068 -5.53606 -7.5515 -27 2 14.9622 15.5552 17.2653 -0.403084 -10.0705 4.87845 -28 1 12.136 13.4022 0.475357 -11.3959 -2.02194 -12.751 -29 2 11.9408 13.3873 18.1673 8.9331 -2.53085 4.8524 -30 2 11.4037 13.9022 0.849725 6.62825 2.84238 11.8203 -31 1 9.29338 5.44787 4.01163 24.6694 12.616 -29.9837 -32 2 8.80858 5.1972 4.76287 -21.098 -14.9153 34.0625 -33 2 8.63435 5.49966 3.31701 -4.42724 -1.21089 -8.36553 -34 1 1.79376 4.18976 11.6282 4.46954 -46.7602 7.51249 -35 2 1.70048 5.09501 11.8512 -4.37305 32.1952 10.6933 -36 2 2.09275 3.70286 12.4334 -4.9207 12.4729 -20.4441 -37 1 2.01732 6.80615 8.34226 1.64844 10.8358 -0.647304 -38 2 2.37448 7.3471 9.0762 -2.77819 -13.6149 -8.9692 -39 2 1.92609 5.89421 8.65385 1.80745 6.26657 1.98394 -40 1 5.38901 4.42498 7.95307 14.0474 9.0477 19.097 -41 2 5.49608 3.48465 7.79451 -4.39314 -7.26091 -3.25333 -42 2 4.79389 4.80722 7.31869 -10.598 0.276841 -18.5158 -43 1 3.29732 2.94293 17.5086 17.2208 -30.0882 -17.6092 -44 2 4.02601 3.30007 16.978 -4.8938 2.423 1.99348 -45 2 2.81217 3.66256 17.8655 -12.7512 26.7583 13.4218 -46 1 7.44366 5.31542 6.10005 -2.04578 -15.3999 -38.6663 -47 2 8.07874 5.97061 6.33436 13.5587 20.8049 21.0336 -48 2 6.95124 5.08125 6.86821 -11.582 -6.53412 22.3247 -49 1 9.78574 7.01841 12.0035 -14.224 -5.31732 -23.9819 -50 2 10.3573 6.41663 11.5027 -2.93892 5.75769 9.08141 -51 2 9.02058 7.16943 11.392 19.9248 1.87014 17.2782 -52 1 14.0222 3.60384 8.07347 21.1656 -3.6634 36.3987 -53 2 13.9951 4.24089 7.37961 -2.65045 17.7741 -13.562 -54 2 14.5465 4.02482 8.8088 -19.0215 -13.1146 -21.9867 -55 1 4.60432 17.1743 3.97092 -4.17058 -8.50894 9.4345 -56 2 5.51528 17.3741 4.10719 24.7317 1.00316 8.45766 -57 2 4.31895 17.8257 3.35422 -16.1123 9.67587 -20.1592 -58 1 16.4938 16.6102 10.1803 -22.58 10.2442 28.8776 -59 2 15.6971 16.8258 10.7464 27.0105 -10.9286 -19.8859 -60 2 16.1827 15.9878 9.51957 -5.57273 -0.00226425 -4.98818 -61 1 1.9645 4.84741 0.368078 -14.0488 -12.8308 -13.2388 -62 2 2.69854 5.15593 0.879033 14.2396 9.43314 15.7095 -63 2 1.5724 5.64147 0.000503254 -0.0595591 4.00938 -5.12573 -64 1 11.6747 13.3071 16.3147 -7.05005 22.2307 18.0491 -65 2 11.0866 12.5598 16.3919 -3.1788 -17.5748 -3.92498 -66 2 12.2584 13.1709 15.5748 2.75178 -8.36686 -13.1919 -67 1 10.131 11.038 16.8986 -21.0542 26.9507 -1.58256 -68 2 10.4848 10.1706 16.8573 15.2828 -28.4038 0.505132 -69 2 9.17797 10.924 16.7712 4.48065 0.743861 -0.190366 -70 1 11.7352 17.4666 13.4614 -1.07936 25.6776 8.56908 -71 2 12.4835 17.2209 12.9203 3.02318 -9.35187 -8.63799 -72 2 11.8077 18.4454 13.5145 -0.798306 -16.7366 -1.43427 -73 1 6.39395 9.3313 12.2301 16.0138 21.1557 17.835 -74 2 6.78657 8.92292 11.474 4.59605 -10.3711 -18.9433 -75 2 7.12055 9.89522 12.5742 -21.4515 -7.31443 1.84288 -76 1 16.2436 12.8045 2.69297 9.19112 6.28957 -1.09055 -77 2 17.1119 13.1995 2.45018 -21.0084 -1.00278 4.98407 -78 2 15.5746 13.5129 2.79044 13.212 -4.74068 -2.98151 -79 1 0.66547 12.6008 5.89246 44.3801 0.278469 12.8923 -80 2 0.944588 12.4662 4.9918 4.15776 -1.70344 -11.3497 -81 2 18.3844 12.6561 5.85431 -44.3715 7.63264 -5.03051 -82 1 5.23201 16.4301 18.4413 -23.1671 11.3407 -2.74477 -83 2 5.81563 15.7669 18.0873 14.8521 -9.88299 1.40517 -84 2 5.51268 16.7513 0.656182 8.57816 -5.72834 2.04059 -85 1 0.568352 7.66823 4.13077 -28.9792 -20.0076 22.3714 -86 2 18.6051 8.03762 3.49503 -7.9612 4.34402 -11.87 -87 2 1.4037 8.01472 3.91532 39.463 15.435 -13.2826 -88 1 3.11888 8.95318 6.49662 60.4725 2.42495 -6.82714 -89 2 3.7308 8.46704 7.08062 -7.96075 9.2896 -8.18079 -90 2 2.27986 8.68504 6.76207 -50.4171 -10.8396 15.4956 -91 1 7.30368 10.3509 16.2473 20.2996 0.0228567 -17.1566 -92 2 6.66358 10.504 15.5564 -7.99994 0.888183 -0.524161 -93 2 6.82737 10.217 17.0566 -12.2765 1.21271 14.6854 -94 1 11.12 1.01485 5.00375 -0.0102216 2.84952 14.1843 -95 2 11.0857 1.87302 4.56078 2.3673 -3.0702 -4.20032 -96 2 10.7324 0.367128 4.41621 -3.73217 -2.39612 -13.1961 -97 1 4.37027 2.7904 13.2033 3.18584 17.5115 -8.99997 -98 2 4.79356 3.08499 14.0007 6.25053 15.0735 9.59097 -99 2 4.18046 1.89747 13.4272 -8.57413 -32.1756 -2.785 -100 1 8.40183 10.1302 1.81819 -11.3119 21.1596 -20.1509 -101 2 8.22596 10.8234 2.46526 3.55036 0.443395 1.34914 -102 2 8.74004 9.40086 2.30376 11.7587 -22.7948 15.5041 -103 1 10.4641 1.71908 15.5611 14.2583 -4.22402 3.33599 -104 2 11.4066 1.52258 15.371 -17.8532 5.60176 1.9802 -105 2 10.08 2.13518 14.7824 5.57904 -1.0897 -7.54918 -106 1 2.70316 12.9014 7.80195 3.19617 10.9991 1.8073 -107 2 3.3212 13.5754 7.49282 0.460726 -0.40643 1.73206 -108 2 2.13336 12.7538 7.04495 -5.07282 -6.75217 -1.11681 -109 1 3.70861 11.6625 5.14703 20.6482 18.5599 0.117703 -110 2 3.55555 10.8287 5.56068 -6.18613 -18.2271 10.4705 -111 2 3.04771 11.7826 4.47739 -15.5561 1.61657 -8.41129 -112 1 6.75631 14.4548 16.9127 8.94674 -1.78931 -0.924301 -113 2 7.71443 14.3361 16.9267 -6.94418 4.38523 0.882829 -114 2 6.52635 14.6721 16.0018 -2.96874 0.297136 0.835917 -115 1 14.1768 14.5549 3.37546 -9.20747 -5.25648 5.53536 -116 2 13.5738 15.2994 3.18581 6.88801 -12.7747 3.05988 -117 2 13.7349 13.9262 3.9882 4.46288 16.3838 -11.0193 -118 1 8.36945 18.1316 16.043 -50.6417 14.5597 -0.377943 -119 2 8.83326 17.39 16.374 32.1095 -21.5179 4.54953 -120 2 8.87194 0.178112 15.6264 24.4627 6.71878 1.23367 -121 1 4.74402 1.66109 4.92978 -19.7446 -31.5867 36.4561 -122 2 3.83516 1.95374 4.92736 -8.28526 7.01041 1.88485 -123 2 5.14187 2.10852 4.23181 25.7722 28.9669 -41.4039 -124 1 15.0327 12.6922 16.4463 -14.1895 -13.4373 -36.9651 -125 2 14.5853 13.1594 17.1179 -4.44761 17.5587 33.5367 -126 2 14.3173 12.6168 15.7704 28.0544 -5.79477 6.54775 -127 1 15.7455 18.4472 16.8494 -36.7721 -17.2537 -45.0168 -128 2 16.3082 18.5742 17.5575 42.6678 12.9246 46.9817 -129 2 15.6033 17.4929 16.845 -6.46687 1.33922 -4.84851 -130 1 1.19925 1.17644 16.5482 3.81725 -14.252 -17.647 -131 2 1.9494 1.76296 16.5282 11.9166 8.08174 5.38627 -132 2 0.720072 1.41993 17.3243 -10.8728 8.87917 17.8692 -133 1 18.1194 4.51517 15.8978 -9.12682 11.3324 16.5545 -134 2 18.3907 3.99589 15.1624 6.35448 -14.0345 -18.3092 -135 2 0.212938 4.54105 16.5062 3.72114 1.23331 1.72655 -136 1 12.2575 16.9791 16.1441 20.307 19.4582 -44.4732 -137 2 11.5756 16.5974 16.6415 -35.2707 -20.5418 23.5889 -138 2 11.9443 16.955 15.2053 9.79722 2.45701 21.3583 -139 1 15.9948 2.53341 18.0767 10.9381 -15.7258 5.9061 -140 2 15.4972 3.23449 18.4655 -6.78731 22.0319 12.1926 -141 2 15.8185 2.63494 17.1497 -1.81081 -2.22204 -19.1287 -142 1 6.71322 13.8205 10.2184 4.21251 -0.72826 -19.8354 -143 2 6.51318 13.5527 11.1172 -1.15071 -8.01371 4.0626 -144 2 6.63912 13.0526 9.6212 -3.83744 4.98216 12.3358 -145 1 10.1462 18.2988 2.74675 -22.097 -20.0437 20.6404 -146 2 10.3757 0.350258 2.15404 6.85623 19.4082 -18.4799 -147 2 9.18692 18.1396 2.61143 20.6475 -0.265938 -2.33946 -148 1 3.01179 17.7216 6.11391 16.3646 11.1083 -7.5066 -149 2 2.20644 17.7129 5.60578 -13.7656 -5.82691 -3.27397 -150 2 3.67703 17.9821 5.44947 -4.29715 -10.1951 11.4126 -151 1 12.5763 16.9057 8.00279 34.6812 6.34788 -19.799 -152 2 11.842 16.3339 7.82778 -18.535 -10.6459 7.52248 -153 2 12.4277 17.4882 8.74445 -13.6741 4.98834 7.73701 -154 1 14.8867 15.2801 8.21669 15.2681 -20.6133 -0.236719 -155 2 14.2473 15.9935 8.15265 -4.83203 2.49296 -8.82369 -156 2 15.4177 15.201 7.39136 -14.8487 16.0275 12.7595 -157 1 17.673 18.2386 0.358056 6.39969 9.72416 1.64776 -158 2 18.5627 17.8182 0.243387 -17.6184 17.4743 1.20562 -159 2 17.7074 0.56338 0.562155 11.394 -25.7036 -4.78753 -160 1 0.840605 10.4115 1.35744 37.4959 50.4012 -24.017 -161 2 0.0672579 9.99096 1.64345 -42.7842 -22.4511 10.6341 -162 2 0.58692 11.2092 0.808654 3.76922 -28.1369 19.051 -163 1 1.6843 12.2358 3.38047 -6.18426 -19.2714 -7.57792 -164 2 1.35621 11.4726 2.83119 9.65923 28.3457 4.48748 -165 2 1.68469 13.0653 2.87986 -2.69674 -10.3555 -4.68476 -166 1 0.583101 17.235 4.89274 4.80321 -10.1773 15.6529 -167 2 18.7212 18.0548 4.74777 -0.344371 -10.7938 17.6071 -168 2 0.457865 16.8228 5.79389 -3.26711 20.5272 -26.9728 -169 1 1.10197 0.931397 9.43269 -15.4399 -19.3078 -9.02275 -170 2 1.25908 0.443364 10.2575 0.781623 10.2528 -2.87546 -171 2 0.281175 0.525265 9.08113 16.3171 12.9297 7.39947 -172 1 16.7532 2.33623 13.2905 -6.48112 -9.83965 38.5991 -173 2 16.8955 2.59135 12.4052 6.16672 6.51778 -37.0535 -174 2 16.4416 1.41783 13.3009 4.47832 4.66932 -0.969858 -175 1 2.60624 15.8504 12.1681 -27.4943 19.2901 -21.9402 -176 2 3.16839 15.391 12.7532 19.3125 -15.6847 20.968 -177 2 2.92961 15.6774 11.278 4.5792 -4.36857 -3.32021 -178 1 16.4212 15.6424 6.03078 2.33398 -27.7044 12.4884 -179 2 17.3276 15.7008 6.32 9.77501 -6.8374 8.24343 -180 2 16.3266 16.4053 5.49767 -10.7497 25.3256 -21.0495 -181 1 5.80196 5.07502 11.792 -7.0375 5.38003 9.08436 -182 2 5.27256 5.62589 12.4097 12.9595 -6.51078 -10.685 -183 2 5.4277 4.18781 11.8485 -2.70068 5.27459 0.5345 -184 1 15.1729 4.86274 0.750774 -1.10571 10.9128 -33.6343 -185 2 15.2042 4.59535 1.64712 -4.27265 -9.78555 34.3171 -186 2 14.3466 5.34824 0.643665 4.19718 -3.49047 -1.12139 -187 1 16.3347 16.3636 2.07743 2.17372 -8.94604 27.567 -188 2 16.248 16.684 3.01162 -4.2135 -4.93901 -27.3972 -189 2 16.5997 17.1143 1.55727 4.53602 12.7734 -5.95158 -190 1 0.261441 4.84804 3.8055 -0.147017 -56.3045 13.8461 -191 2 0.475233 5.74211 3.84367 9.07909 56.4423 -0.745388 -192 2 0.927869 4.41838 4.37361 -9.48651 2.83213 -9.85838 -193 1 2.95802 15.0603 15.1014 -0.943114 0.172839 -27.3629 -194 2 2.80338 14.7297 15.9709 -3.98201 -9.31011 23.138 -195 2 2.36314 15.8122 15.0164 6.10514 4.60789 3.27938 -196 1 1.13815 14.652 9.54287 -29.9359 -26.3887 42.7894 -197 2 1.85794 14.2975 9.07203 33.137 -5.88851 -26.0645 -198 2 1.02375 13.9289 10.2175 -6.6715 26.0405 -18.8729 -199 1 13.5762 16.6063 11.5459 8.2131 -23.6119 0.793767 -200 2 13.33 17.296 10.9485 -9.11427 22.0857 -7.2987 -201 2 13.1805 15.8285 11.1175 -0.169415 1.89227 9.19008 -202 1 4.67714 1.46335 0.758621 16.4224 4.90719 -8.19047 -203 2 4.16601 2.0159 0.158762 -4.20381 1.9839 -0.0593356 -204 2 4.09672 0.7797 1.07984 -10.7002 -7.55851 6.47825 -205 1 1.4518 18.552 11.8572 6.2605 -28.7314 5.6203 -206 2 1.30143 0.363179 12.6934 -0.382356 1.32639 0.00372943 -207 2 1.68394 17.6168 12.0771 -1.80479 24.861 -1.36748 -208 1 11.5075 10.1198 4.02095 -18.4811 -8.70186 23.5865 -209 2 11.1917 10.5684 3.24759 -2.79925 6.67004 -19.1711 -210 2 12.4478 10.2129 4.02159 23.6747 0.339266 0.782627 -211 1 8.31226 12.1774 3.6909 13.3967 -8.0925 -50.6166 -212 2 9.08853 12.6634 3.95409 8.19758 6.83683 10.985 -213 2 7.73108 12.1161 4.40989 -25.5486 3.81511 42.2514 -214 1 14.4234 4.01167 3.27932 -6.39999 -0.808874 -15.5703 -215 2 15.0318 4.04602 4.01015 9.81333 2.6424 13.2185 -216 2 13.6949 4.61166 3.47516 -0.628596 -1.04819 4.76047 -217 1 5.60276 1.68001 7.51543 46.6974 51.3536 -38.165 -218 2 4.99884 1.09753 7.87161 -47.5789 -43.021 28.4342 -219 2 5.32972 1.80197 6.58421 6.01087 -7.11276 10.7862 -220 1 17.8847 1.08156 4.86879 -16.2479 -18.084 1.95698 -221 2 18.6198 1.37964 4.35055 14.6356 14.0949 -7.48199 -222 2 17.763 1.66674 5.61639 2.20316 6.60999 2.39214 -223 1 6.81142 9.41573 4.49306 -0.655622 0.432156 7.98772 -224 2 6.876 9.60924 5.45033 2.30801 -5.82211 -14.8304 -225 2 7.69814 9.2085 4.16641 0.21776 -0.211816 8.23149 -226 1 2.64622 14.9044 1.97705 -19.6169 -6.34757 32.4999 -227 2 3.24366 14.6749 2.7111 -2.05224 3.38495 -12.0409 -228 2 3.14951 14.9574 1.1885 18.3224 0.185563 -21.7099 -229 1 17.3026 12.9105 13.1506 5.97988 10.8617 -4.35729 -230 2 16.4943 13.3715 13.3508 -17.5214 -4.76439 4.13034 -231 2 17.8495 13.6655 12.9025 6.83053 -7.65676 -2.15198 -232 1 14.953 10.5544 1.38215 35.2581 29.1908 17.9973 -233 2 15.5812 11.2612 1.74238 -25.4064 -29.0048 -15.0024 -234 2 14.0938 10.9575 1.42777 -9.92862 1.12257 -1.65093 -235 1 5.7132 6.77849 4.57909 1.57168 19.8101 -12.7812 -236 2 6.1646 7.64962 4.62346 -11.1008 -12.4177 -0.29751 -237 2 6.30742 6.13992 4.97063 6.93571 -3.41618 11.3539 -238 1 8.02607 8.31482 10.3199 -6.67367 -6.11991 -5.1902 -239 2 8.5826 9.1064 10.2496 0.567217 -7.04018 -13.4516 -240 2 7.81744 7.96553 9.42928 8.80325 8.4252 13.4279 -241 1 13.463 18.3942 5.75922 18.2094 9.72717 -25.7917 -242 2 12.7029 0.253225 5.44631 -3.25776 3.56949 4.30859 -243 2 13.1448 17.7819 6.40042 -11.4028 -12.4364 22.7676 -244 1 0.157572 2.62906 0.18715 -8.27583 -44.4001 -2.30616 -245 2 17.9404 2.90438 -0.139246 -4.84787 10.7772 1.25282 -246 2 0.728557 3.33866 0.428035 8.4047 29.5908 2.16632 -247 1 12.7834 11.0467 9.74512 50.2143 -37.9981 33.2215 -248 2 11.9361 11.0491 9.39224 -54.8114 3.18277 -19.015 -249 2 12.8684 10.1188 10.1004 3.84712 25.3375 -10.5627 -250 1 0.745434 12.1889 11.0782 -25.5268 2.00553 -1.18025 -251 2 18.4134 12.2219 11.1204 10.6569 -0.780029 -7.62666 -252 2 1.00048 12.4147 11.9671 12.4315 1.99225 10.3147 -253 1 5.08453 7.29937 13.4403 2.24753 -3.99956 1.86213 -254 2 5.64891 7.85147 12.8757 -3.98378 2.58677 10.115 -255 2 5.52437 7.26557 14.3066 0.821915 -2.02828 -9.69703 -256 1 1.22699 6.88005 11.8698 42.6355 29.3241 27.8417 -257 2 0.513102 7.24659 11.3736 -15.3023 8.70694 -9.89945 -258 2 1.76616 7.68013 12.1994 -27.3906 -36.7234 -16.475 -259 1 15.5048 9.56381 12.3059 14.0365 -21.5239 -8.17825 -260 2 15.0446 10.3738 12.2505 -11.2614 35.3449 -7.27588 -261 2 15.2981 9.243 13.1696 0.51668 -8.53923 17.0206 -262 1 16.6213 12.8097 5.50479 11.7533 -20.9364 35.7876 -263 2 16.4281 13.7341 5.58129 -4.58024 20.9264 -6.48074 -264 2 16.496 12.5383 4.61195 -7.15835 1.38375 -28.6034 -265 1 6.25272 9.92074 0.051253 25.5558 -5.2213 19.2814 -266 2 5.65499 10.4134 0.617489 -6.63873 2.74854 -0.55683 -267 2 7.09279 9.88715 0.575545 -19.794 1.5448 -11.6918 -268 1 12.3217 6.11544 4.06855 24.0308 27.0278 -26.8963 -269 2 12.2667 6.69224 3.25542 -0.750296 -12.6773 27.7542 -270 2 11.603 5.51542 4.01585 -23.4349 -14.6267 -3.11795 -271 1 0.228308 12.8043 0.188232 11.1572 0.898125 2.61316 -272 2 0.191448 13.5221 0.829575 -7.01271 0.62324 2.49922 -273 2 18.423 13.1312 18.0517 -4.48315 2.42872 -7.20237 -274 1 3.7281 18.597 8.57641 -7.3642 13.4464 17.6561 -275 2 3.55952 18.0214 7.8301 -5.82536 1.28732 -6.71467 -276 2 2.87154 0.379366 8.79158 11.2944 -8.20129 -4.53508 -277 1 7.45075 17.3023 4.47746 -12.4687 -31.8552 -5.62811 -278 2 7.62794 18.1881 4.68695 9.53175 40.2972 16.7849 -279 2 7.50734 17.3052 3.52795 -1.99738 -6.99443 -12.8094 -280 1 9.24058 17.0897 12.2501 -24.9009 9.53262 -6.54721 -281 2 9.25026 16.4035 11.594 -4.50925 -12.7792 -11.7902 -282 2 10.1098 17.0766 12.5981 28.7243 3.47903 16.8433 -283 1 13.2876 12.9366 7.99409 13.1339 47.0026 -12.7195 -284 2 13.3658 12.2269 8.61754 6.78146 -9.97429 11.7811 -285 2 13.946 13.6564 8.215 -16.5737 -23.9385 -2.8436 -286 1 14.9278 2.97205 15.3542 -22.0243 3.95222 27.314 -287 2 14.2978 2.24466 15.255 3.92553 0.418625 -2.59085 -288 2 15.495 2.9795 14.6023 14.212 -3.72656 -21.152 -289 1 9.88733 15.5502 16.9939 -6.96656 2.06857 9.21519 -290 2 10.3024 14.7219 16.7214 3.24805 0.519307 1.1538 -291 2 9.47388 15.4159 17.8681 4.17307 -0.448199 -10.2742 -292 1 11.3272 8.33778 16.5655 -12.1447 -4.13113 3.07889 -293 2 10.5941 7.97459 16.029 11.4521 -0.447246 11.036 -294 2 11.3675 7.80686 17.3849 -1.98947 6.30133 -12.9317 -295 1 3.91087 18.2078 16.7523 8.10648 -24.8729 2.7978 -296 2 4.29329 17.4751 17.2712 -2.30537 5.45923 -13.1249 -297 2 3.83261 0.235403 17.405 -4.96911 23.3333 9.68201 -298 1 2.20524 4.16671 8.93127 -30.922 4.24465 -33.9389 -299 2 3.10409 4.18899 8.66341 29.7515 -2.18627 -0.590115 -300 2 2.16419 4.10976 9.8632 4.73941 -5.36165 36.7803 -301 1 9.8752 10.3748 9.71669 16.1383 -34.8575 15.3318 -302 2 9.43878 11.1114 9.34267 -12.9257 32.2344 -10.6144 -303 2 10.0704 10.5459 10.6459 0.567735 2.49547 1.17829 -304 1 9.70603 0.859612 10.8594 11.2219 3.05072 8.41213 -305 2 9.26848 0.0594607 11.2011 -2.07101 7.3453 -10.3505 -306 2 9.18365 1.30902 10.1791 -6.8322 -10.1071 2.86508 -307 1 9.20299 15.1273 10.2305 31.122 11.5717 5.63223 -308 2 8.76871 15.6899 9.60445 -9.85228 15.7354 -8.32779 -309 2 8.63472 14.3875 10.3233 -23.0991 -20.0884 3.25194 -310 1 0.96837 9.47951 10.2963 -70.5876 8.50765 14.6853 -311 2 0.835229 10.4182 10.5095 11.9906 -6.34251 -2.52384 -312 2 1.84768 9.33537 10.0919 56.817 -0.102153 -14.2985 -313 1 16.9556 4.85371 8.1764 15.2186 15.5475 -39.5257 -314 2 16.4324 5.61135 8.41217 -10.5813 9.18021 7.17639 -315 2 16.8473 4.22258 8.84986 -2.43363 -23.5078 29.961 -316 1 14.6968 14.7113 0.249291 21.1749 6.84176 -19.9636 -317 2 15.2416 15.0749 0.948116 1.7369 4.80193 6.96981 -318 2 13.9408 14.343 0.670519 -22.6431 -9.26918 11.3127 -319 1 3.62773 11.0513 9.55661 13.6415 -11.4582 11.5887 -320 2 3.64622 11.3868 10.4653 -1.2087 2.23818 -2.33891 -321 2 3.18854 11.7052 9.01978 -9.00441 8.94912 -6.83793 -322 1 11.1486 10.7845 1.39435 -11.9859 -27.9615 14.113 -323 2 11.4982 11.6036 1.1014 8.88176 28.2378 -14.4203 -324 2 10.2242 10.7355 1.11217 4.88573 2.00485 1.40976 -325 1 13.1617 7.12114 12.7848 27.9985 9.25187 0.204961 -326 2 14.1485 7.05909 12.8492 -22.0105 -1.86773 -1.16605 -327 2 12.8387 6.22307 12.8528 -4.13181 -6.51108 -0.646654 -328 1 9.62686 1.89618 0.979059 -11.1933 -2.25437 -17.4068 -329 2 8.86583 1.44793 0.536192 15.085 16.0595 8.12302 -330 2 10.1008 2.43338 0.313674 -4.24921 -13.4265 6.88026 -331 1 10.6169 13.5248 4.60784 -18.2432 -3.19473 -12.9411 -332 2 11.3551 12.9251 4.5569 15.1862 -3.85234 3.34493 -333 2 10.6581 13.9134 5.47279 3.49634 8.81883 14.723 -334 1 14.3649 1.74425 10.9305 5.54735 -12.1033 0.31392 -335 2 15.2006 1.47853 10.5325 -1.1471 -9.04293 -1.43649 -336 2 14.4646 2.6903 10.9924 -3.65076 12.6994 -0.169483 -337 1 14.6084 12.2765 11.688 7.48969 -0.0414248 52.7612 -338 2 15.3889 12.4412 11.1797 12.3837 0.874018 -20.9659 -339 2 13.8613 12.0797 11.1652 -22.2598 -6.69151 -32.5036 -340 1 8.22131 5.06515 9.81151 31.4859 -23.4564 -24.7693 -341 2 7.50576 5.35441 10.3398 -29.672 2.17434 15.6894 -342 2 8.09879 4.11038 9.58602 -2.47918 22.6636 6.16193 -343 1 1.53723 16.856 18.3772 -4.91865 -38.0309 19.5229 -344 2 1.81973 17.2424 17.568 8.52952 11.4507 -22.0862 -345 2 1.68062 15.8825 18.2332 -2.55663 27.9439 5.8223 -346 1 1.48989 17.248 15.3251 -39.2991 7.69546 7.77355 -347 2 1.63979 18.1273 15.7491 -10.9611 -20.0854 -9.27397 -348 2 0.505086 16.9983 15.3475 43.8724 16.6347 0.193712 -349 1 3.67894 5.68848 6.10927 6.21387 -9.44646 -9.55971 -350 2 3.15123 6.21186 6.69497 -13.0277 9.84767 14.8728 -351 2 4.18038 6.32117 5.58457 4.58642 -2.3545 -2.10993 -352 1 12.397 9.46521 14.1943 -11.4291 42.6821 2.6577 -353 2 12.6884 8.68898 13.7764 17.0449 -39.3969 -17.6043 -354 2 12.207 9.20402 15.087 -1.24705 -6.16332 16.3323 -355 1 4.0418 15.2774 6.91931 -38.8927 -2.71008 6.44315 -356 2 3.58633 16.0735 6.61178 -2.62598 -4.70343 -0.502904 -357 2 4.94439 15.4914 6.84844 41.7142 6.1892 -4.79175 -358 1 0.605801 8.58372 14.9539 0.254512 0.326548 7.88367 -359 2 0.527439 9.52499 15.1145 -2.4036 7.40824 2.35469 -360 2 1.30759 8.52231 14.3126 8.3049 -1.83762 -9.50966 -361 1 12.9717 8.29262 10.2927 -22.7594 16.3387 10.1639 -362 2 13.6731 7.84025 9.84078 14.5836 -10.6745 -2.92467 -363 2 13.0109 8.02582 11.2281 0.923047 -2.44701 -11.6389 -364 1 15.3232 7.71175 3.53457 4.84131 -0.438878 0.085747 -365 2 14.6048 7.2242 3.18847 -27.3478 1.70601 -26.568 -366 2 15.5504 7.10949 4.22607 20.3905 5.82918 25.2924 -367 1 17.3123 6.68101 0.0543458 25.2448 -11.5383 1.06581 -368 2 16.8643 5.84811 0.208139 -4.52976 -2.78536 3.6701 -369 2 16.6324 7.27442 18.4294 -24.004 18.1506 -8.07094 -370 1 8.88314 6.92259 7.79709 31.0126 27.4325 -12.7619 -371 2 9.82162 7.25311 7.83141 -27.6614 -7.83044 -3.12143 -372 2 8.85418 6.18364 8.38751 -5.1761 -15.9168 16.933 -373 1 12.3742 0.616612 1.23426 0.620177 6.71182 8.7173 -374 2 13.3152 0.448787 1.38768 -5.31542 -0.309906 -0.296651 -375 2 12.0908 0.227811 0.410291 5.35555 -3.35826 -6.33914 -376 1 5.63073 15.1419 14.5354 -14.6404 -24.282 5.65856 -377 2 4.69276 15.2374 14.754 2.80482 -4.42056 0.607876 -378 2 5.89918 16.0006 14.2671 15.2941 25.5531 -11.1631 -379 1 3.85325 6.46699 1.73385 7.01958 -17.0097 2.38606 -380 2 3.51461 7.31896 1.46783 -8.17546 12.9796 -1.79528 -381 2 4.05434 6.54403 2.67764 -3.63249 4.46552 -6.11981 -382 1 3.88854 11.6061 12.3354 -12.5844 1.40703 6.82309 -383 2 4.76337 11.9285 12.5525 8.64878 0.03141 -1.44708 -384 2 3.2838 12.173 12.8501 6.64476 -9.03704 -9.92286 -385 1 5.37483 3.86954 15.8708 7.06931 -74.8011 -5.77053 -386 2 6.14587 3.26348 15.6611 -29.2279 19.2574 6.80998 -387 2 5.70286 4.72315 15.8147 21.5682 55.4234 -2.96121 -388 1 14.3763 10.2794 4.46201 -32.4101 28.4329 49.0365 -389 2 14.443 9.83621 5.32683 0.971611 4.81404 -7.53945 -390 2 14.839 9.74155 3.87936 25.2894 -34.3452 -37.3821 -391 1 7.80918 17.3929 9.15872 22.1479 -28.1908 5.37522 -392 2 6.96403 17.5587 9.551 -17.6194 9.20761 3.63927 -393 2 7.9906 17.9725 8.42371 -6.45863 11.4679 -7.92664 -394 1 4.50911 14.4925 3.93603 -3.72296 -18.8397 -53.7951 -395 2 4.39275 15.3834 4.18687 0.185157 34.2159 14.5975 -396 2 4.6886 13.9787 4.68865 6.61933 -20.0316 37.8242 -397 1 14.2759 7.39669 15.8018 -25.3443 -8.35453 -18.4147 -398 2 15.2098 7.32722 15.7472 31.3188 -3.09541 -3.64929 -399 2 14.1076 7.77613 16.6483 -2.08075 9.82337 20.7866 -400 1 2.98131 18.2876 1.92072 -8.89863 -34.7534 -28.0783 -401 2 2.43865 17.6277 1.38436 23.5626 24.7731 19.3405 -402 2 2.37413 0.302092 2.22775 -14.7638 14.2119 8.82016 -403 1 7.98427 1.62335 4.57287 -40.8947 -0.445207 11.16 -404 2 7.39585 2.15768 4.00383 13.1095 -6.60943 2.01257 -405 2 8.85324 1.63658 4.22836 26.1363 6.2526 -15.7033 -406 1 2.50726 14.1431 17.6951 16.6159 21.4268 -10.1577 -407 2 1.94925 13.5738 18.1946 -18.2656 -19.6261 9.9334 -408 2 3.40865 13.8863 17.9244 2.82527 -4.33175 1.96247 -409 1 0.811695 1.74837 13.8925 -21.7292 3.59652 4.70406 -410 2 0.795118 1.42008 14.8166 -3.87613 7.88135 -16.9479 -411 2 18.5211 1.96459 13.6307 25.6616 -9.0685 11.0917 -412 1 4.4852 18.6484 13.9168 -33.7534 10.3053 3.09674 -413 2 5.3921 18.406 13.9761 25.2496 -8.78408 2.09715 -414 2 4.08373 18.5038 14.7912 8.14506 -1.30426 -6.00867 -415 1 7.12802 0.652367 18.3595 35.0739 -19.2419 -26.0317 -416 2 7.40845 0.19154 17.5185 -9.63956 16.0629 26.4358 -417 2 6.18456 0.683953 18.3433 -21.3742 6.93569 3.25827 -418 1 16.0657 18.4123 14.0301 53.2891 7.60066 12.7833 -419 2 15.2177 18.2242 13.7261 -48.7282 -11.4797 -7.69178 -420 2 16.0808 18.482 14.9966 -9.66087 4.27341 -2.7923 -421 1 10.0672 4.54369 16.2573 46.2132 32.473 -7.3661 -422 2 10.9795 4.93172 16.0704 -30.9355 -10.7562 9.7222 -423 2 10.2805 3.63455 16.4071 -7.05314 -22.7581 -0.39686 -424 1 15.904 17.802 4.45553 44.7656 -19.4466 -14.3322 -425 2 16.4088 -0.0282793 4.41597 5.24747 5.32524 1.83839 -426 2 15.0633 18.045 4.74212 -51.1512 14.4852 15.4733 -427 1 6.99737 17.3998 13.7879 -47.9218 -2.31875 -13.0268 -428 2 7.40243 17.6398 14.5891 19.7576 8.98543 35.5766 -429 2 7.70074 17.2583 13.1843 23.2619 -4.97282 -20.0499 -430 1 13.2941 6.48376 6.64986 8.60711 15.0683 16.7306 -431 2 13.9993 7.1541 6.49159 -11.9149 -19.7057 -4.80273 -432 2 12.8211 6.29295 5.83939 3.46216 6.87198 -11.4398 -433 1 7.76205 2.3443 9.26472 15.7579 10.991 45.3998 -434 2 7.20759 2.25447 10.0765 8.01487 -1.94761 -18.5756 -435 2 7.26048 2.06297 8.52639 -23.6607 -10.4133 -22.8687 -436 1 15.1706 14.8583 13.6757 15.7984 -16.1031 1.44613 -437 2 15.0167 15.231 14.5413 -6.09806 3.71972 9.46304 -438 2 14.6225 15.2955 13.0407 -11.5903 11.1836 -9.13521 -439 1 9.36431 8.31687 3.74781 -9.55399 11.9025 -3.42765 -440 2 10.1518 8.60925 4.20014 9.2003 9.72282 -0.0746101 -441 2 9.3553 7.37835 3.87681 -0.285781 -17.995 1.20514 -442 1 17.7597 13.5616 16.4405 -12.156 -24.6438 9.82021 -443 2 16.8551 13.2283 16.3395 1.48334 1.58847 4.06975 -444 2 17.7289 14.3961 16.0037 5.37456 23.0458 -12.1714 -445 1 4.95841 10.6088 2.75519 -22.9294 18.7883 -14.1686 -446 2 5.66909 10.277 3.27928 16.3083 -8.75526 16.0734 -447 2 4.6114 11.3873 3.23357 6.81328 -15.8641 -4.024 -448 1 3.73362 8.35206 10.1813 3.02598 13.3252 -21.6654 -449 2 3.8939 9.27056 9.86724 -4.6548 -13.2191 9.23973 -450 2 3.49789 8.39898 11.1021 -0.178845 4.23779 13.7606 -451 1 16.0042 7.01418 6.13738 -12.6879 19.8807 -2.17242 -452 2 16.808 7.4479 6.40937 10.6213 6.47779 2.98579 -453 2 16.2019 6.09716 6.06821 5.44302 -25.895 -2.3467 -454 1 15.1221 7.07483 9.10103 -4.15707 -25.1338 32.4641 -455 2 15.7464 7.4872 9.69859 9.03801 3.43378 3.13104 -456 2 15.1481 7.58948 8.33098 1.37226 23.8896 -40.0507 -457 1 6.35284 13.0135 12.8052 -0.193314 -18.9728 -17.7547 -458 2 7.21044 12.6571 13.0708 -4.00291 0.344811 4.20755 -459 2 6.11805 13.741 13.3614 0.492624 18.505 17.8288 -460 1 12.1195 4.49733 13.0969 -26.0004 -21.5883 -29.3264 -461 2 12.1632 4.68913 14.0325 -4.53328 -3.39715 11.6105 -462 2 11.3073 3.93318 12.8667 31.5163 26.387 18.3053 -463 1 11.3554 8.17046 7.8728 -3.27026 2.45633 -4.65198 -464 2 12.0683 7.62612 7.54639 6.23155 -9.6048 -12.5756 -465 2 11.5676 8.24955 8.79484 1.17104 5.44951 18.1694 -466 1 17.1791 10.8374 7.47157 -22.685 17.097 10.0101 -467 2 17.8401 10.2117 7.26521 25.6893 -28.4186 -0.815308 -468 2 17.2004 11.4333 6.72646 -9.08817 8.64759 -4.95169 -469 1 5.26928 18.1244 11.0251 26.2987 0.0330793 2.18763 -470 2 4.69547 17.8637 11.7317 -9.61751 -4.26247 14.7568 -471 2 4.70076 18.4264 10.3375 -16.9 2.57743 -21.8459 -472 1 7.59635 17.5306 1.81531 -10.9531 4.1869 -25.2725 -473 2 7.77056 16.6988 1.31883 2.24077 21.8764 10.5056 -474 2 7.30155 18.2046 1.15131 11.3055 -17.5184 13.1347 -475 1 1.92843 12.8944 13.5862 -6.59595 -16.5477 -16.8116 -476 2 1.43666 12.2821 14.1316 -5.58333 -5.88714 5.06202 -477 2 2.04362 13.6601 14.1181 9.10211 24.5058 14.6097 -478 1 9.63922 6.76943 14.8194 -3.94612 -18.0692 3.52162 -479 2 9.76751 5.80583 15.0218 -0.27339 26.7602 -8.06829 -480 2 9.98245 6.98264 13.9392 -2.96138 -9.43899 0.82382 -481 1 15.2804 4.29771 10.7711 -7.29951 -1.41697 -0.334277 -482 2 16.1821 4.02615 11.0218 -9.71269 11.8498 1.69675 -483 2 14.9105 4.9568 11.3864 17.8049 -7.45406 -3.59162 -484 1 11.2365 6.16159 0.180514 3.71779 6.92115 0.875598 -485 2 11.3264 5.36714 18.3195 14.2335 -18.3801 -6.22284 -486 2 10.2946 6.26806 0.197414 -17.1549 12.9032 2.71424 -487 1 0.0669242 11.3685 15.0652 13.212 -6.85086 18.3683 -488 2 18.0421 11.4114 14.3938 -11.7915 7.94746 -16.0964 -489 2 -0.126536 12.1197 15.6445 1.80559 0.362507 -3.06694 -490 1 7.04679 9.22841 7.26069 23.2883 20.8536 -5.26127 -491 2 6.49897 8.58869 7.67863 -15.4435 -25.8158 9.46312 -492 2 7.95399 8.89143 7.34084 -8.97527 1.37154 -2.4384 -493 1 18.3457 15.377 12.3544 -10.4554 -0.385944 -2.00928 -494 2 0.632165 15.4053 12.1583 18.2501 2.20759 0.366712 -495 2 17.9344 15.8751 11.6412 -4.56296 -0.981709 -1.73702 -496 1 16.5292 4.37759 5.24858 18.1125 19.5767 -27.8403 -497 2 16.7661 4.20984 6.14013 0.307987 -10.9951 33.7785 -498 2 17.3779 4.70209 4.86684 -19.0742 -11.8317 -4.1687 -499 1 17.7267 3.12899 10.7335 -24.2941 -12.2101 -5.28174 -500 2 18.5902 3.43151 10.9823 20.7538 0.196381 3.18907 -501 2 17.7917 2.2294 10.3565 4.74658 11.2046 4.02468 -502 1 12.2912 0.000462328 10.1205 5.29277 -42.3116 -12.7781 -503 2 11.463 0.345322 10.3908 -30.9755 9.64408 8.62664 -504 2 12.8898 0.704281 10.2182 28.9402 34.0259 3.93413 -505 1 10.3772 9.78855 12.3993 -21.9688 -12.411 -17.7787 -506 2 11.0129 9.78765 13.1014 16.013 1.76066 13.7043 -507 2 10.1738 8.8461 12.2399 4.72709 11.7982 0.616329 -508 1 0.569471 2.8284 7.02034 6.04311 -30.2491 -2.51113 -509 2 0.820763 3.41522 7.71636 2.48105 19.4463 13.5049 -510 2 0.862153 1.97327 7.38155 -6.15059 8.48947 -7.95665 -511 1 0.371359 15.3036 6.90441 -15.8595 21.8666 50.0789 -512 2 0.449232 14.6844 7.65301 -0.190166 17.9034 -2.10351 -513 2 0.621967 14.7945 6.18679 16.5003 -37.2512 -48.0182 -514 1 17.0414 7.00877 15.2159 -22.6634 4.89001 -1.64325 -515 2 17.7376 7.6544 15.0563 8.01654 -6.9456 2.15019 -516 2 17.4056 6.16817 15.5101 9.28872 0.897926 -1.45041 -517 1 9.06316 12.4266 8.08985 69.8766 6.47542 -0.0200154 -518 2 9.44101 11.8026 7.43298 -17.7999 4.13897 6.91255 -519 2 8.14431 12.4062 8.1331 -54.6706 -8.19385 -9.80298 -520 1 1.26891 1.85581 2.9921 11.7044 -8.67905 12.4997 -521 2 0.561231 2.0509 2.38915 -6.84046 11.4219 -12.1453 -522 2 1.65109 2.68456 3.32008 -5.2596 -5.54909 -2.36563 -523 1 4.11753 15.1048 9.79523 4.78264 -4.87511 12.6416 -524 2 3.99332 15.4569 8.91057 5.07926 -2.88804 -4.85995 -525 2 5.03278 14.7822 9.88586 -9.66079 5.58119 -5.37355 -526 1 7.25278 2.18203 14.6254 -0.555581 -14.0599 -5.06396 -527 2 7.1005 1.71681 13.7878 -2.90711 2.6098 7.34806 -528 2 7.71992 2.97108 14.3713 4.55177 12.8631 -2.10328 -529 1 18.557 14.6494 2.1729 -24.7771 22.3853 -4.36836 -530 2 0.778963 15.0461 2.09778 12.8139 1.02797 3.11036 -531 2 17.9275 15.4159 2.12338 10.4684 -24.8222 2.25012 -532 1 9.97282 2.76121 12.909 0.960373 12.9666 17.7509 -533 2 9.84581 2.0662 12.2717 -5.76657 -8.74665 -14.3806 -534 2 9.17654 3.31629 12.9308 6.08178 -3.78367 -5.74316 -535 1 2.89833 8.91803 13.044 14.9503 3.68581 0.826535 -536 2 3.29774 9.80788 12.9186 -7.17545 -13.4779 0.185991 -537 2 3.62224 8.34145 13.3619 -7.75262 8.46695 -4.72395 -538 1 3.21711 8.45664 3.69888 -1.45646 11.2765 -73.7917 -539 2 3.66926 9.20612 3.219 -10.9411 -20.3742 19.6072 -540 2 3.34915 8.55803 4.60102 11.7629 13.1896 57.1484 -541 1 5.60205 7.18882 8.56127 11.7766 6.17403 -13.6051 -542 2 5.73377 6.23122 8.60856 -5.21401 3.91262 5.39773 -543 2 5.15686 7.50265 9.34977 -6.87961 -7.75657 6.1504 -544 1 14.8989 1.38427 1.96946 -15.0866 25.6457 3.84218 -545 2 14.4906 2.19786 2.32837 7.96598 -16.9425 9.74227 -546 2 14.9786 1.62425 1.05302 13.5137 -6.97514 -15.0219 -547 1 8.3539 15.1902 0.828571 -0.607384 -15.7884 -3.69873 -548 2 9.11456 14.9295 1.35098 9.06641 9.90213 6.9538 -549 2 7.64957 14.6447 1.20074 -5.27592 0.575252 -4.39528 -550 1 15.5904 1.35118 7.21966 19.131 18.1941 14.0102 -551 2 15.0458 0.788774 6.70847 -19.486 -21.9805 -16.5491 -552 2 15.0172 2.08736 7.44992 -1.58717 6.06663 4.11757 -553 1 4.99095 13.0428 18.5017 -11.814 -5.03203 -22.7016 -554 2 5.38558 13.1981 0.699871 9.67176 2.40993 22.9792 -555 2 5.69857 13.2122 17.8695 -3.662 3.61759 -0.881885 -556 1 15.3616 8.52427 18.1264 -8.5134 -8.81723 23.808 -557 2 15.7284 8.98559 17.3934 10.1937 15.818 -24.0842 -558 2 15.2728 9.20414 0.16849 -1.83009 -5.75583 -0.912989 -559 1 12.0932 3.04939 18.3516 -14.5656 24.4873 8.42937 -560 2 12.4759 2.51827 0.417994 -2.38649 -9.33387 -9.98316 -561 2 12.2916 2.69447 17.4847 9.72648 -15.0074 2.48816 -562 1 13.2068 12.6815 5.17314 -7.19784 6.47098 -0.665029 -563 2 13.7108 11.8878 4.96601 4.53767 0.295949 3.70661 -564 2 13.3847 12.9363 6.09127 2.00425 -11.4311 -4.02895 -565 1 6.06883 7.14745 0.0914664 -7.81354 22.5487 2.98517 -566 2 5.88319 8.11419 0.19427 8.4279 -22.2037 -4.79949 -567 2 5.22519 6.72532 0.292473 3.10856 -0.243494 3.48057 -568 1 17.7194 15.9325 14.9871 -5.54638 -4.40987 -28.7902 -569 2 16.9069 16.4169 14.9498 -12.3977 10.2544 17.1316 -570 2 17.7594 15.7087 14.0393 19.0068 -3.79668 12.8095 -571 1 13.1727 0.977833 16.5926 -11.6444 6.00991 -1.45652 -572 2 14.0026 0.708875 16.9779 14.0624 -0.886732 -0.671765 -573 2 12.7076 0.152182 16.4397 -1.15444 -5.20647 -2.10321 -574 1 11.0384 14.6069 7.3103 -17.4066 -34.6271 2.52502 -575 2 10.2783 14.0261 7.58336 17.6612 20.778 -3.294 -576 2 11.8174 14.0391 7.44317 -4.14385 7.222 1.39489 -577 1 17.5379 8.55913 2.08836 4.35413 -11.6997 -13.5411 -578 2 16.664 8.39738 2.48219 7.20941 -2.48593 -6.20174 -579 2 17.6519 7.91106 1.34391 -7.20398 14.5397 25.454 -580 1 12.3635 7.91649 1.96817 14.6342 -23.934 -0.413214 -581 2 11.8532 8.69875 2.12901 -10.659 13.0689 -1.52352 -582 2 11.9409 7.3888 1.27378 0.548374 7.65925 3.61612 -583 1 11.9419 14.6308 10.3966 13.4402 32.5881 48.4479 -584 2 12.2905 14.0069 9.8182 12.9115 -34.2012 -37.3181 -585 2 11.0351 14.785 10.1903 -23.9611 0.860738 -9.13817 -586 1 6.84298 6.98317 15.5594 -28.1276 -29.1686 -18.0428 -587 2 7.705 6.91496 15.176 20.6419 5.27277 -3.3528 -588 2 6.85291 7.68491 16.1747 6.25697 23.8787 22.837 -589 1 8.01998 4.63032 13.4448 -35.0292 -26.7707 -36.5428 -590 2 7.42844 4.80515 12.6548 14.5268 -5.56395 32.2217 -591 2 8.43798 5.44118 13.6312 16.8653 30.885 3.99265 -592 1 13.3984 12.173 14.3104 -3.57217 10.7678 8.64565 -593 2 13.233 11.2355 14.1881 -1.19303 -4.98427 -3.70246 -594 2 13.8945 12.4998 13.5522 0.86121 -3.67781 -4.0367 -595 1 14.7231 9.47939 7.26845 -4.38272 9.59825 17.375 -596 2 15.5232 10.0108 7.49545 -18.3981 -9.5314 -3.88615 -597 2 14.0057 9.68134 7.91225 20.1628 1.06432 -13.939 -598 1 12.7179 16.9622 3.14627 23.4566 -37.2939 -10.6207 -599 2 12.9355 17.1415 4.04114 9.03221 7.6908 26.6047 -600 2 12.0213 17.5358 2.94483 -34.3001 33.1559 -14.5415 -601 1 1.10947 7.12267 17.419 -6.10821 -8.12856 16.9857 -602 2 0.178422 7.136 17.6887 4.23762 -2.5375 0.360706 -603 2 1.14096 7.54201 16.5672 -1.29203 8.00191 -14.7545 -604 1 12.8573 5.07319 15.6916 -26.4132 -0.426227 -0.347566 -605 2 13.5067 4.42508 15.4662 18.5417 -18.6841 0.103563 -606 2 13.3354 5.89586 15.6754 6.08426 15.3432 1.29959 -607 1 2.44451 3.37888 5.09109 -12.3042 -30.7639 -30.2825 -608 2 1.89914 3.20439 5.84354 -15.8924 -6.60657 16.2411 -609 2 2.9157 4.14854 5.30475 25.2943 38.046 11.4255 -610 1 8.30318 11.1757 13.537 -17.7368 31.3122 -83.5918 -611 2 8.23756 10.9827 14.4193 9.23305 -26.2584 72.471 -612 2 8.98641 10.7011 13.0548 11.9243 -7.18625 13.6047 -613 1 12.9121 1.44799 13.2982 3.17544 -30.959 19.595 -614 2 13.5829 1.31511 12.6431 13.7174 -5.57278 -14.8203 -615 2 12.5671 2.27513 13.0597 -18.9903 37.7092 -4.23536 -616 1 6.45025 13.6395 2.14169 21.7214 -12.6454 -10.4453 -617 2 5.88722 14.0323 2.78408 -20.3944 14.637 16.9787 -618 2 7.03563 13.0797 2.67163 0.317992 1.20831 -5.89746 -619 1 15.9341 6.54969 12.734 7.51439 18.2634 -8.82177 -620 2 16.366 7.12442 12.0552 -8.93517 -14.9663 18.1444 -621 2 16.3202 6.79095 13.5987 -1.79943 -6.04596 -11.4359 -622 1 16.8134 0.715269 9.59469 1.51011 24.5111 -1.75686 -623 2 16.9773 18.4324 9.6759 -2.99022 -25.9416 6.21625 -624 2 16.4855 0.841275 8.69831 -5.26956 1.43879 -3.58435 -625 1 6.14183 11.6821 8.34851 2.12045 33.7206 2.80541 -626 2 5.25373 11.5769 8.68031 -11.2997 -2.21294 6.8592 -627 2 6.41363 10.8186 8.10997 12.8023 -29.2169 -10.6172 -628 1 2.82878 8.69633 0.366162 65.7357 7.98524 25.914 -629 2 2.25196 8.1872 18.4995 -43.1364 -19.0897 -25.1642 -630 2 2.39827 9.3921 0.850531 -20.8372 5.7472 0.329713 -631 1 10.1125 10.4546 6.55694 -3.88563 -4.31924 12.8938 -632 2 10.5628 9.81084 7.11921 -1.26662 -0.776779 -0.718706 -633 2 10.7076 10.6109 5.83303 6.58413 -0.38446 -16.1853 -634 1 6.75197 15.7318 6.59922 10.1749 2.21511 -7.15796 -635 2 7.21229 16.0038 7.38721 0.121014 2.00215 12.9298 -636 2 7.17446 16.2736 5.9175 -9.12202 -3.23328 -2.5626 -637 1 6.44006 13.071 5.66115 9.01876 9.03356 -0.68679 -638 2 6.7952 13.9213 5.9766 -6.67057 -7.15315 -1.80184 -639 2 6.02558 12.6573 6.41982 -1.29087 -3.79345 3.79648 -640 1 16.7894 12.5351 9.7661 -6.01106 14.3853 23.3751 -641 2 16.9466 11.9627 9.02496 7.22561 -5.83165 -16.8213 -642 2 17.1452 13.4178 9.59292 -0.312151 -9.66884 -5.48162 -643 1 6.11103 2.94777 2.80745 -0.0522908 21.1759 -16.381 -644 2 6.20729 3.87808 2.49328 4.01665 -19.1858 15.5438 -645 2 5.82625 2.47942 2.01203 -2.73031 -5.31149 4.59086 -646 1 10.8562 3.22295 3.2592 5.83487 -6.01133 1.10343 -647 2 10.3184 3.99141 3.45824 -8.06424 0.347936 -1.44444 -648 2 10.5285 2.8344 2.43843 -2.26863 2.18612 2.83427 -ITEM: TIMESTEP -50 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.76267 6.9614 17.9655 18.039 1.32171 0.971735 -2 2 7.88851 7.04905 18.3237 -17.7355 -1.2272 4.07533 -3 2 8.77103 6.18416 17.4071 -1.73171 -4.43635 -4.46665 -4 1 18.7148 8.30367 6.79977 -11.0979 19.7573 -45.8218 -5 2 0.340011 8.13606 5.84126 -7.49685 -0.624375 38.3142 -6 2 0.514278 7.70743 7.38333 14.5888 -19.2797 9.57425 -7 1 8.47639 18.6969 6.83361 -13.2294 -1.25401 8.78355 -8 2 9.37315 0.218195 6.58559 19.0885 2.32763 -3.91705 -9 2 7.98208 0.748711 6.39478 -2.33131 3.58411 -1.86541 -10 1 6.52812 1.78346 11.693 -34.4751 -1.18092 9.20038 -11 2 5.67737 2.21709 12.0036 34.6116 -15.9045 -8.19534 -12 2 6.27488 0.856486 11.479 2.31906 19.7771 3.09659 -13 1 7.04596 5.66579 2.40189 46.2065 -42.3734 -14.42 -14 2 6.39782 6.00892 2.95716 -37.9245 28.3982 32.5204 -15 2 6.93615 6.04049 1.54428 -8.317 15.9019 -18.5798 -16 1 16.2302 10.236 16.0835 20.9593 -16.5275 2.4245 -17 2 17.1756 10.4542 16.2372 -23.2351 0.455296 -7.02457 -18 2 15.6872 10.9657 16.3738 0.757377 12.3052 3.78761 -19 1 10.6519 14.9414 2.32488 9.23959 14.6152 1.78567 -20 2 10.6414 14.4628 3.16471 0.797937 2.29677 -5.70575 -21 2 11.1604 15.7599 2.50148 -7.89724 -14.8548 -1.26363 -22 1 17.1653 8.24769 10.628 -7.00673 -3.15457 9.83212 -23 2 16.8168 8.85992 11.2947 -1.87186 0.196375 -6.64951 -24 2 17.9222 8.68524 10.2369 7.99899 3.60318 -1.68622 -25 1 14.7266 15.9157 16.4191 -13.8739 15.1565 -8.48964 -26 2 13.7936 16.2384 16.3951 24.1732 -8.40377 0.758561 -27 2 14.8582 15.5746 17.3097 -4.06225 -5.68183 -0.795501 -28 1 12.1165 13.3951 0.497647 12.4663 -12.7582 1.83308 -29 2 11.9617 13.3954 18.1814 -7.51799 5.11576 7.21512 -30 2 11.4424 13.8646 1.00511 -0.599491 5.86198 -7.65109 -31 1 9.3022 5.46358 3.98483 37.3 9.28522 -25.3544 -32 2 8.76176 5.25183 4.70521 -26.4917 -13.7331 37.3539 -33 2 8.69012 5.59126 3.27137 -14.2398 -0.31671 -15.324 -34 1 1.75646 4.13824 11.6126 7.13571 -34.631 6.10286 -35 2 1.57168 5.01735 11.8974 -3.49495 27.0073 7.26754 -36 2 2.15491 3.66767 12.3745 -6.50879 7.63382 -13.9832 -37 1 2.03017 6.80422 8.30837 9.29028 16.8447 12.8872 -38 2 2.52076 7.32809 8.97976 -10.1379 -7.93343 -11.4013 -39 2 1.79129 5.98703 8.76166 3.66627 -1.3648 -7.3534 -40 1 5.38278 4.45139 7.96045 1.48715 2.78745 -0.615366 -41 2 5.47525 3.53905 7.69237 2.73507 -15.0654 6.73754 -42 2 4.91072 4.84535 7.233 -11.388 9.54401 -10.9371 -43 1 3.30811 2.94776 17.4802 13.944 -42.282 -21.1312 -44 2 3.9986 3.21817 16.868 2.68053 3.29728 -0.298822 -45 2 3.01647 3.72731 17.8911 -19.397 34.8415 21.3069 -46 1 7.43048 5.35311 6.10326 -4.25319 -13.0158 -27.7806 -47 2 8.09022 5.89476 6.48364 23.034 26.3027 15.5228 -48 2 6.99872 4.97144 6.84559 -15.3695 -14.0963 19.964 -49 1 9.79676 7.01231 12.0156 -14.7328 3.59156 -15.7655 -50 2 10.3705 6.43202 11.4882 -9.23999 6.31012 5.56299 -51 2 9.04301 7.2927 11.4294 23.3546 -9.34629 13.9639 -52 1 14.0089 3.6286 8.06931 13.5755 5.11429 34.4728 -53 2 14.0074 4.36435 7.46412 -2.30693 7.62473 -7.33974 -54 2 14.3705 4.00595 8.91563 -10.4749 -13.1534 -24.8623 -55 1 4.55657 17.1558 3.95973 -9.28017 -24.3455 25.7085 -56 2 5.47914 17.3407 4.055 21.0307 11.7367 -4.03215 -57 2 4.1348 17.6911 3.31263 -3.95253 16.2794 -25.0192 -58 1 16.4751 16.614 10.2504 -32.3258 -7.85569 21.4695 -59 2 15.6275 16.6356 10.7813 29.977 2.99208 -16.9651 -60 2 16.2718 15.9944 9.53771 -1.01186 4.78751 -1.5712 -61 1 1.9619 4.81867 0.319959 -10.9755 -9.70287 -18.0846 -62 2 2.61752 5.08919 0.942567 15.1261 9.15008 18.4356 -63 2 1.74644 5.61951 -0.161427 -5.07436 5.04444 -4.19633 -64 1 11.5961 13.2841 16.3358 -4.45358 14.5896 10.2849 -65 2 11.0454 12.5131 16.3954 -10.7816 -16.1685 4.94665 -66 2 12.1536 13.1064 15.5876 11.3576 1.56581 -12.6168 -67 1 10.1325 11.0245 16.8746 -17.0839 37.329 0.881875 -68 2 10.5383 10.188 16.8005 14.1256 -36.2582 -1.95739 -69 2 9.19072 10.9065 16.7053 -0.138929 -3.60954 1.11764 -70 1 11.7656 17.449 13.475 -8.50487 25.248 2.18402 -71 2 12.3632 17.1066 12.8073 4.24528 -3.45864 -2.0733 -72 2 11.8231 18.4283 13.4081 4.57434 -16.4673 0.201387 -73 1 6.41878 9.35136 12.2283 -7.50229 14.2202 21.4939 -74 2 6.8057 8.89086 11.4896 12.6266 0.651555 -6.79619 -75 2 7.09031 9.88696 12.7035 -9.91308 -10.3657 -12.0835 -76 1 16.2619 12.8358 2.69678 7.42582 31.4023 -4.83963 -77 2 17.0939 13.3284 2.51069 -14.3032 -16.3414 4.28546 -78 2 15.5824 13.5473 2.68145 7.19887 -17.4175 4.43499 -79 1 0.698809 12.6212 5.89369 35.48 3.16674 13.5988 -80 2 0.938081 12.5288 4.97754 4.92149 -4.10163 -12.4931 -81 2 18.4194 12.7439 5.90006 -39.8609 3.63618 -4.1467 -82 1 5.237 16.4363 18.426 1.65878 -0.316472 9.22308 -83 2 5.81108 15.7548 18.0954 4.21498 -13.4949 -13.2329 -84 2 5.56972 16.5656 0.670239 -4.67124 7.34541 5.05152 -85 1 0.592121 7.69947 4.15467 -58.6061 -26.6762 36.9237 -86 2 18.6393 8.0928 3.5307 -12.7545 6.31849 -14.8448 -87 2 1.4218 7.85573 3.82511 72.6481 19.3185 -25.9209 -88 1 3.11983 8.96532 6.48794 54.6199 12.7003 -22.2767 -89 2 3.76913 8.45297 6.98254 -4.7725 1.8296 2.92636 -90 2 2.27977 8.75705 6.803 -46.0396 -12.4219 19.8369 -91 1 7.29807 10.3702 16.2638 20.6686 -0.114663 -24.6428 -92 2 6.66655 10.506 15.5642 -5.16108 2.7891 -5.34334 -93 2 6.78521 10.2638 17.0451 -10.3715 -1.64006 24.8745 -94 1 11.1174 0.987619 5.00277 -7.18116 3.53088 7.25248 -95 2 11.0089 1.86145 4.60844 7.25629 1.31859 -0.585836 -96 2 10.7387 0.391071 4.35918 -2.65397 -7.99376 -8.61355 -97 1 4.35641 2.82374 13.2083 -1.43301 42.1246 -29.6721 -98 2 4.74578 3.12447 14.0221 1.91906 -0.955597 13.0676 -99 2 4.17771 1.91012 13.264 -5.21231 -41.1093 14.0839 -100 1 8.41102 10.1748 1.81577 -7.29686 12.4487 -22.3398 -101 2 8.22152 10.8552 2.46036 0.4991 6.95458 5.373 -102 2 8.69583 9.43786 2.3232 10.7851 -24.1065 14.6426 -103 1 10.4306 1.70557 15.5491 18.4702 5.47966 -9.86629 -104 2 11.3921 1.67519 15.3716 -14.7227 -5.4908 8.94093 -105 2 10.0695 2.09393 14.7416 -3.28742 -2.92827 -1.64813 -106 1 2.67775 12.9037 7.82287 3.09642 7.69249 12.8714 -107 2 3.27779 13.5956 7.51776 -0.922255 -1.64886 -5.76029 -108 2 2.01429 12.7843 7.13996 -0.0248334 -2.64481 -5.98892 -109 1 3.74038 11.6511 5.07858 19.3958 17.4162 2.05128 -110 2 3.60589 10.7736 5.39333 -4.06789 -18.6575 13.0804 -111 2 3.07486 11.8033 4.42286 -17.2397 4.77378 -8.56343 -112 1 6.72135 14.4316 16.9296 11.8603 14.2358 -0.0778856 -113 2 7.64698 14.6853 17.0511 -5.38436 -3.23295 2.03342 -114 2 6.43726 14.8986 16.1349 -2.65892 -7.20284 -3.09426 -115 1 14.1884 14.544 3.35185 -21.8252 -0.368401 10.0779 -116 2 13.5247 15.1958 3.05461 14.5314 -4.887 4.26149 -117 2 13.7567 14.0734 4.09815 10.0173 4.52685 -16.1607 -118 1 8.41325 18.11 16.0503 -13.4237 14.7481 -2.40694 -119 2 9.01353 17.4146 16.1754 14.4883 -45.0972 12.851 -120 2 9.02228 0.139466 15.7926 3.66197 31.0187 -5.55304 -121 1 4.74026 1.68368 4.91774 -8.81747 -38.2992 48.653 -122 2 3.89365 2.07173 5.09257 -16.8489 9.86366 -0.181142 -123 2 5.05165 2.08173 4.1548 23.8621 30.7653 -48.3713 -124 1 15.012 12.6397 16.4637 21.182 -20.8114 -27.7575 -125 2 14.6363 13.1316 17.1743 -19.1608 12.2632 11.0748 -126 2 14.4002 12.4571 15.7145 4.23163 12.8017 20.733 -127 1 15.7141 18.464 16.8736 -48.8091 1.63943 -48.6642 -128 2 16.4537 18.5656 17.3974 52.451 1.55627 42.8989 -129 2 15.6088 17.527 16.6934 -4.99653 -8.13868 6.26406 -130 1 1.24245 1.19714 16.5568 -3.35795 -9.15112 -9.15157 -131 2 2.06126 1.67967 16.5955 12.2536 9.19 1.95012 -132 2 0.738255 1.56007 17.2754 -9.1343 5.49748 13.2621 -133 1 18.1403 4.48045 15.9024 -8.92064 9.41796 12.6958 -134 2 18.2534 3.91822 15.1507 3.10214 -9.7063 -13.7449 -135 2 0.333051 4.53253 16.3579 6.8431 0.540548 1.72555 -136 1 12.2576 16.9773 16.1451 24.3374 26.4028 -39.8206 -137 2 11.5235 16.7559 16.6626 -39.484 -19.8089 22.2101 -138 2 11.9275 17.1263 15.229 8.36672 -7.61232 16.8746 -139 1 16.0311 2.54163 18.1267 15.2184 -17.5558 18.8253 -140 2 15.6351 3.35325 18.4083 -9.02057 20.5203 4.48377 -141 2 15.9018 2.48695 17.1953 -7.32995 1.76863 -25.4669 -142 1 6.72575 13.8191 10.1968 -9.26978 -14.9128 -14.7006 -143 2 6.45064 13.4802 11.0509 2.35225 3.79258 9.11016 -144 2 6.47529 13.1065 9.58166 7.75573 8.69288 2.20437 -145 1 10.1667 18.3423 2.73278 -21.0918 -24.4685 17.5154 -146 2 10.3808 0.422697 2.17354 8.51297 19.7321 -20.8009 -147 2 9.25877 18.0911 2.47579 12.4496 3.13566 3.08398 -148 1 3.02618 17.7182 6.12046 9.12785 6.17449 -5.85825 -149 2 2.19895 17.4959 5.67953 0.482163 3.05546 -3.6427 -150 2 3.66706 17.9189 5.4073 -11.2068 -9.39986 11.0759 -151 1 12.5962 16.8879 7.98687 8.69067 0.386489 -7.96768 -152 2 11.911 16.2378 7.93697 -12.2796 -18.2514 -9.64148 -153 2 12.3467 17.3792 8.75804 4.49939 18.0195 12.184 -154 1 14.8895 15.2713 8.19847 3.78441 6.77747 -24.1674 -155 2 14.0908 15.8092 8.10802 0.530475 -1.70182 9.59272 -156 2 15.3507 15.4528 7.3473 -4.11878 -7.96121 22.2836 -157 1 17.7044 18.2264 0.345927 53.2191 22.2557 3.1655 -158 2 18.611 17.8064 0.306571 -34.334 1.581 -6.33561 -159 2 17.9464 0.534475 0.465882 -17.8927 -21.106 -0.514669 -160 1 0.816649 10.4426 1.34739 14.8692 48.9775 -23.6448 -161 2 0.0612409 10.0129 1.68761 -29.4632 -23.0248 11.5333 -162 2 0.465717 11.2339 0.843051 15.2672 -28.7963 15.4324 -163 1 1.72991 12.2406 3.39174 -15.9976 -2.88445 -44.3457 -164 2 1.42407 11.5936 2.70825 8.45982 5.87631 22.8389 -165 2 1.72198 13.0652 2.87637 5.68226 -3.3333 12.0496 -166 1 0.611993 17.231 4.90821 -34.3512 10.3394 53.8078 -167 2 18.7649 18.0776 4.93361 14.0145 -8.94618 -14.8948 -168 2 0.320128 16.8659 5.79609 20.9887 -2.41003 -36.5782 -169 1 1.10304 0.897417 9.42158 -11.0752 -12.4205 -5.86027 -170 2 1.33193 0.471936 10.271 -7.8206 6.77035 -10.9921 -171 2 0.260273 0.49253 9.11811 18.1645 10.0729 11.6017 -172 1 16.7431 2.34345 13.2996 -3.12231 -7.25082 27.0749 -173 2 16.9139 2.55723 12.403 6.00909 8.65593 -29.5603 -174 2 16.479 1.41627 13.3001 1.0866 -1.80785 3.13205 -175 1 2.64585 15.864 12.1283 -21.2463 14.7527 -7.08654 -176 2 3.15605 15.3934 12.7599 11.6364 -10.3414 18.5671 -177 2 3.00262 15.6045 11.2815 4.79088 -2.17896 -11.8296 -178 1 16.4298 15.6598 6.07287 -23.7839 -45.9221 18.6798 -179 2 17.316 15.6562 6.39936 21.0579 5.20152 4.08476 -180 2 16.3078 16.3335 5.44341 2.1367 33.4546 -25.3893 -181 1 5.80337 5.0927 11.7988 -16.1764 10.2154 8.68093 -182 2 5.24436 5.75105 12.277 17.1169 -11.9851 -7.24057 -183 2 5.28663 4.27668 11.796 1.81497 4.13117 2.00496 -184 1 15.1635 4.86687 0.779797 10.276 15.6296 -42.8981 -185 2 15.0374 4.47718 1.61189 -4.55383 -15.7546 43.9488 -186 2 14.356 5.34586 0.597493 -2.57536 1.02491 -2.93315 -187 1 16.3458 16.3763 2.04771 3.47576 3.66541 23.8501 -188 2 16.2044 16.7006 2.97252 -3.72753 -7.68524 -25.3267 -189 2 16.7389 17.1226 1.58867 -0.552753 3.82143 -4.99822 -190 1 0.255881 4.83863 3.82235 -11.3764 -61.9515 -5.66134 -191 2 0.347221 5.7447 3.93716 8.7619 60.1171 8.48532 -192 2 0.834328 4.39842 4.45398 2.37129 4.71095 -1.99834 -193 1 2.9563 15.0569 15.1257 1.71124 8.82343 -41.1566 -194 2 2.85861 14.8634 16.033 -5.32392 -14.5435 34.6784 -195 2 2.48389 15.8911 15.0234 3.12674 0.885842 0.387353 -196 1 1.13777 14.6522 9.5263 -30.3315 0.106042 24.0606 -197 2 1.89024 14.3075 9.07024 17.4708 -15.5826 -4.95385 -198 2 0.933623 14.0402 10.2733 8.29602 9.54759 -23.1661 -199 1 13.5292 16.584 11.5416 25.6454 -21.6132 21.0377 -200 2 13.328 17.2834 10.9465 -13.4726 19.9213 -18.5602 -201 2 13.2496 15.765 11.1158 -9.99742 3.11837 -0.28929 -202 1 4.66126 1.44669 0.76776 24.0608 13.759 -10.2694 -203 2 4.19513 2.00271 0.14116 -5.95148 5.85957 -2.67997 -204 2 4.06121 0.755814 1.00952 -11.6339 -11.0076 11.757 -205 1 1.46276 18.5641 11.8468 9.16484 -20.9655 21.4802 -206 2 1.29795 0.448688 12.6433 2.09315 -1.75191 -4.75625 -207 2 1.84947 17.7191 12.1761 -6.39306 18.521 -9.12508 -208 1 11.4915 10.1299 3.99438 -29.0311 -19.3551 44.8744 -209 2 11.2201 10.4871 3.17848 -8.25775 15.5063 -35.6965 -210 2 12.4189 10.233 4.02648 37.0944 1.09916 3.99775 -211 1 8.27499 12.1796 3.66337 18.6814 -7.12196 -36.2468 -212 2 9.0689 12.5922 3.98877 11.875 7.24467 3.22649 -213 2 7.6764 12.2152 4.36849 -32.1167 2.17346 40.1921 -214 1 14.4874 4.01368 3.28039 -17.5005 -0.0616197 -21.9184 -215 2 14.9648 3.93911 4.08552 21.5727 -0.139675 21.9436 -216 2 13.7566 4.60071 3.48465 -5.84393 1.34015 1.64127 -217 1 5.62374 1.66322 7.51635 70.0554 58.4457 -44.6253 -218 2 5.02312 1.16941 7.9611 -67.4835 -53.4064 45.1295 -219 2 5.39821 1.60037 6.57846 0.425083 -1.20148 0.902483 -220 1 17.8844 1.0604 4.85627 -10.0966 -7.93422 8.12116 -221 2 18.57 1.49808 4.37578 15.6561 4.82809 -15.3219 -222 2 17.6975 1.64814 5.58583 -4.12013 1.11537 7.77052 -223 1 6.80576 9.4106 4.49942 14.9318 -4.14838 16.3077 -224 2 6.92469 9.61899 5.44741 -8.81338 -3.93454 -14.2946 -225 2 7.68422 9.10473 4.22333 -4.88591 1.73472 -0.668879 -226 1 2.61188 14.876 1.98504 -6.91902 -4.93882 19.1315 -227 2 3.25848 14.7083 2.68056 -2.68924 0.660774 0.84214 -228 2 3.12462 14.9058 1.19269 5.2127 1.18228 -19.2613 -229 1 17.303 12.9246 13.1525 10.3788 -12.5807 -3.95397 -230 2 16.4389 13.2985 13.3385 -0.36563 10.0164 -0.276732 -231 2 17.9169 13.6449 12.9311 -14.7092 -1.11942 1.9762 -232 1 14.9246 10.553 1.38722 24.8563 30.4026 18.8772 -233 2 15.5245 11.2788 1.76222 -27.4309 -28.2887 -15.3922 -234 2 14.0162 10.8271 1.54897 4.06804 -0.689498 -1.36825 -235 1 5.72717 6.70809 4.58418 -6.56467 23.581 -8.85087 -236 2 6.06385 7.62371 4.66236 -8.01259 -10.4186 -5.73866 -237 2 6.2767 6.1943 5.16785 8.48743 -6.29877 6.22452 -238 1 8.0009 8.33508 10.3687 14.1913 1.83663 -35.3126 -239 2 8.52082 9.13006 10.161 -0.0651459 -5.63876 7.89795 -240 2 7.94932 7.91253 9.48819 -6.75295 -2.00865 18.056 -241 1 13.4409 18.4268 5.72382 16.6357 0.722738 -15.7997 -242 2 12.6296 0.221713 5.47389 -5.04693 11.9449 -2.85301 -243 2 13.1936 17.8965 6.46343 -5.47963 -14.8645 21.1785 -244 1 0.0859293 2.63743 0.236192 -9.12202 -35.143 -2.56963 -245 2 17.9325 2.9505 -0.168165 -24.3821 -4.07692 -4.34214 -246 2 0.590564 3.4143 0.297916 33.333 32.0117 7.87133 -247 1 12.8395 11.0444 9.74231 45.1743 -31.9509 26.4779 -248 2 11.9686 11.0602 9.42407 -43.5447 -1.91263 -10.9888 -249 2 12.9558 10.1388 10.1456 -3.41612 23.6256 -14.6869 -250 1 0.710059 12.1592 11.0756 -10.531 -0.362272 -11.4251 -251 2 18.3753 12.1255 11.106 13.0957 4.94421 7.25875 -252 2 1.07349 12.4339 11.9177 -3.83141 1.58371 11.017 -253 1 5.10203 7.3136 13.4291 15.7719 5.5957 -0.396148 -254 2 5.6162 7.93373 12.8769 -6.75271 -3.40235 8.70115 -255 2 5.62723 7.25347 14.2483 -7.64248 -3.9813 -9.01905 -256 1 1.21129 6.85545 11.8946 29.9494 36.4661 12.0403 -257 2 0.485742 7.25442 11.415 -4.88796 -0.516932 -2.56673 -258 2 1.80546 7.64481 12.127 -26.2797 -36.2571 -7.59378 -259 1 15.5076 9.61367 12.3051 21.7085 -42.1446 -13.9552 -260 2 15.1772 10.4675 12.1584 -16.5272 42.565 -1.064 -261 2 15.3545 9.37182 13.2055 -3.21788 1.51701 18.7315 -262 1 16.6116 12.7513 5.5295 7.16384 -7.58562 22.1279 -263 2 16.3878 13.6701 5.61583 -3.61437 18.1746 3.54477 -264 2 16.4616 12.5615 4.61757 -3.38991 -5.42355 -25.0954 -265 1 6.3014 9.86096 0.0280098 12.3864 1.00447 14.78 -266 2 5.6246 10.4136 0.42972 -1.13337 -0.2267 2.50286 -267 2 7.03571 9.82087 0.686012 -15.2579 5.10695 -14.0237 -268 1 12.3034 6.12839 4.06739 18.1147 15.8957 -28.6536 -269 2 12.3348 6.66771 3.23063 -4.28261 -10.1618 29.3394 -270 2 11.5855 5.52112 3.9529 -14.8183 -8.35162 -1.01689 -271 1 0.289245 12.8118 0.17396 1.00074 4.7721 1.62068 -272 2 0.031574 13.4709 0.828681 0.933398 1.09562 1.96647 -273 2 18.4473 13.0492 18.0252 -3.3255 1.79332 -7.06642 -274 1 3.67377 18.6092 8.59256 -12.2718 12.3972 8.90671 -275 2 3.51633 18.2244 7.72678 0.0355868 -3.61867 -2.60117 -276 2 2.80982 0.36536 8.82196 13.0622 -5.69839 -0.636093 -277 1 7.44701 17.3263 4.47819 -12.2479 -42.1382 8.27198 -278 2 7.47198 18.2285 4.71954 7.46065 34.1282 3.2472 -279 2 7.59543 17.2523 3.54279 -0.328999 6.68987 -14.4609 -280 1 9.24493 17.1077 12.2387 -39.9724 15.9122 -7.56371 -281 2 9.27102 16.3677 11.6468 4.90539 -16.8252 -9.88175 -282 2 10.091 17.2207 12.6154 35.0883 -2.17581 15.9571 -283 1 13.2831 12.983 8.01599 31.7457 23.9761 -1.258 -284 2 13.3856 12.1913 8.53584 -3.88389 -9.78552 5.15809 -285 2 14.1414 13.4672 8.16531 -29.1617 -3.59582 -8.01118 -286 1 14.8948 2.98524 15.3712 -17.5751 0.764594 21.5491 -287 2 14.1876 2.34218 15.2724 -1.25262 -5.58382 2.64656 -288 2 15.4061 2.89645 14.5861 17.2961 2.13088 -20.5882 -289 1 9.89537 15.5662 16.9902 -4.09035 4.17693 9.89685 -290 2 10.2983 14.7234 16.7502 5.73332 1.10161 -2.59445 -291 2 9.67249 15.5035 17.9343 -2.60097 -1.56266 -9.87078 -292 1 11.3274 8.38795 16.5853 -21.4847 -13.5698 4.02619 -293 2 10.6433 7.93033 16.0536 12.1725 7.69909 5.41873 -294 2 11.2563 7.95351 17.4557 6.17465 6.37506 -11.4872 -295 1 3.9593 18.2162 16.7697 0.697619 -14.1615 -14.1273 -296 2 4.40283 17.477 17.2226 -3.01571 14.2153 3.03122 -297 2 3.77495 0.26362 17.3949 3.98021 5.349 11.1126 -298 1 2.22376 4.19593 8.92134 -23.2189 1.10906 -21.9008 -299 2 3.13693 4.25168 8.71451 27.6214 0.869066 -8.80864 -300 2 2.192 4.13003 9.85498 -3.77747 -6.53541 33.4183 -301 1 9.87956 10.3806 9.72418 15.1316 -34.7661 11.7533 -302 2 9.43202 11.1334 9.41625 -17.3542 37.4051 -17.5479 -303 2 10.0318 10.5223 10.6578 4.66737 -1.93825 10.7585 -304 1 9.70627 0.903434 10.8708 -16.6391 -17.8124 -8.64764 -305 2 9.32253 0.0380009 11.0933 9.22807 5.63208 7.52542 -306 2 9.08638 1.2149 10.1967 9.10725 8.78511 -0.274781 -307 1 9.19757 15.1031 10.2247 30.2853 16.2782 3.75492 -308 2 8.7691 15.7671 9.69642 -6.57671 14.9232 -6.79792 -309 2 8.58248 14.3993 10.2376 -24.9838 -23.9988 3.33467 -310 1 0.938497 9.56303 10.2766 -19.6808 1.12411 10.869 -311 2 0.864208 10.4264 10.69 -4.58503 2.29603 -0.877129 -312 2 1.8082 9.5891 9.92621 21.6362 -6.44505 -13.6115 -313 1 17.0002 4.85339 8.15215 21.2107 4.17599 -32.9154 -314 2 16.5226 5.60356 8.44909 -16.9553 23.1583 5.35412 -315 2 16.856 4.21761 8.81327 -1.81027 -27.4365 28.1652 -316 1 14.7301 14.7112 0.178334 14.6842 0.804622 -15.2869 -317 2 15.1474 15.2511 0.844024 6.42123 6.45952 11.8737 -318 2 13.9865 14.3021 0.591484 -20.7841 -7.92944 9.37323 -319 1 3.69091 11.0487 9.53568 5.98335 -8.96355 13.8332 -320 2 3.56651 11.2839 10.4631 4.16949 4.48414 3.3219 -321 2 3.23005 11.7193 9.04032 -8.2098 7.45463 -11.8198 -322 1 11.2005 10.7579 1.45634 -8.62161 -19.8695 4.90197 -323 2 11.5404 11.5862 1.17391 12.694 26.4047 -12.3165 -324 2 10.2904 10.7467 1.15081 -4.44873 -2.97897 0.910453 -325 1 13.1494 7.14877 12.735 25.4211 -2.46103 0.847156 -326 2 14.1287 7.02261 12.7655 -19.3043 2.68773 1.11168 -327 2 12.7806 6.27183 12.8763 -3.1166 -1.04351 -1.25783 -328 1 9.62343 1.89491 0.979311 -12.9604 6.63616 -29.4885 -329 2 8.7946 1.64267 0.49669 19.6199 4.62861 14.6045 -330 2 10.1494 2.42868 0.345455 -5.12075 -11.8177 11.3147 -331 1 10.6335 13.514 4.5646 -17.0056 -0.486025 -1.57099 -332 2 11.3585 12.913 4.68456 17.6411 -7.84828 -0.965736 -333 2 10.6299 14.042 5.36013 -0.769181 5.74096 10.189 -334 1 14.4133 1.73933 10.9414 -11.8391 -17.207 6.29742 -335 2 15.2077 1.35218 10.5638 5.14778 2.73806 -3.87278 -336 2 14.5015 2.69292 10.9149 5.22965 5.71868 -2.86675 -337 1 14.5722 12.1975 11.686 14.094 -1.05888 37.2495 -338 2 15.3017 12.3928 11.129 31.2021 7.92611 -10.369 -339 2 13.8916 12.0994 11.0714 -43.9062 -9.54665 -27.6985 -340 1 8.20779 5.06885 9.81189 17.2837 -27.279 -13.9945 -341 2 7.476 5.2926 10.3565 -21.7486 9.79802 13.7153 -342 2 8.11585 4.0945 9.69767 5.61634 21.6585 -4.44102 -343 1 1.51211 16.8659 18.4077 -7.21278 -21.5738 6.32543 -344 2 1.92778 17.2486 17.641 3.99023 3.9685 -12.2343 -345 2 1.4425 15.9033 18.1995 7.9863 23.2313 7.90302 -346 1 1.50475 17.27 15.3217 -52.6385 22.4638 18.049 -347 2 1.49283 18.1952 15.6793 7.67726 -26.1665 -10.1971 -348 2 0.544177 16.9836 15.4083 37.5739 4.67989 -9.3974 -349 1 3.64958 5.72975 6.08508 6.29069 -26.5723 -11.3796 -350 2 3.20343 6.25343 6.73323 -12.457 15.9806 12.721 -351 2 4.14586 6.29176 5.4852 3.70859 6.95385 1.18178 -352 1 12.4272 9.46789 14.1967 -22.2867 60.9428 4.59069 -353 2 12.8141 8.72569 13.8244 25.5413 -52.6107 -24.0302 -354 2 12.2248 9.22264 15.0865 -2.36671 -8.29514 20.866 -355 1 4.05215 15.2773 6.93811 -37.3363 -16.6714 15.1212 -356 2 3.52112 16.0418 6.69595 1.88806 4.21981 -3.16255 -357 2 4.93922 15.5036 6.7631 37.0693 10.9568 -7.31607 -358 1 0.634621 8.6113 14.9988 -1.00168 -8.57623 6.03626 -359 2 0.426563 9.53409 15.1284 -0.450123 11.8509 1.14186 -360 2 1.36493 8.60238 14.3834 7.02364 0.17651 -8.78598 -361 1 12.9488 8.28918 10.2591 -12.3232 2.05195 12.3522 -362 2 13.6164 7.77926 9.80228 8.67745 -2.84232 -3.45719 -363 2 12.9296 7.914 11.161 -0.920073 6.75149 -12.343 -364 1 15.3287 7.72887 3.53701 30.7324 40.0945 -27.1654 -365 2 14.5687 7.40616 3.08394 -23.025 -16.3354 4.19175 -366 2 15.5452 7.39964 4.39595 -10.5646 -17.2283 18.769 -367 1 17.3078 6.69366 0.0430756 19.9915 -9.88107 5.38445 -368 2 16.7705 5.94464 0.294276 -4.0765 -7.9871 3.32428 -369 2 16.6874 7.33606 18.3865 -21.7939 19.8828 -6.94939 -370 1 8.91017 6.93043 7.77699 23.4025 28.7729 -7.70378 -371 2 9.81824 7.33337 7.84479 -23.824 -15.1706 -1.9244 -372 2 8.86104 6.22236 8.40836 -0.772968 -13.4081 16.1446 -373 1 12.3843 0.611213 1.25908 1.98263 -0.697807 -4.79042 -374 2 13.323 0.393307 1.31761 -0.925839 8.32556 5.35041 -375 2 12.1237 0.465738 0.350227 -1.33982 -4.5367 -2.71568 -376 1 5.61465 15.1448 14.5392 -1.26631 -30.1046 6.25467 -377 2 4.66418 15.2406 14.6702 -0.2102 4.52428 0.84195 -378 2 5.97383 15.921 14.1393 5.11494 24.4221 -7.05072 -379 1 3.84895 6.44034 1.72963 2.7696 -8.11358 7.79979 -380 2 3.51864 7.3032 1.48291 -7.06055 11.1725 -5.60147 -381 2 3.99368 6.51729 2.68239 -0.0521329 1.22822 -5.4234 -382 1 3.90083 11.5778 12.3664 -12.9911 -8.32668 -3.5509 -383 2 4.78352 11.9371 12.4749 4.25232 1.56379 3.39016 -384 2 3.29545 12.1182 12.8978 7.28302 -2.19426 -6.07273 -385 1 5.34262 3.87885 15.873 -6.15348 -82.0204 -11.7996 -386 2 6.0076 3.23261 15.5032 -15.8888 19.1459 15.4213 -387 2 5.69117 4.71679 15.7838 27.5644 60.3601 -6.10452 -388 1 14.3156 10.2471 4.51115 -35.9806 40.7967 42.7391 -389 2 14.5125 9.92103 5.39777 -3.50802 -2.54983 -0.445713 -390 2 14.828 9.75135 3.94137 33.3968 -38.7315 -40.7643 -391 1 7.75287 17.3919 9.13705 13.5919 -13.2315 -4.02741 -392 2 6.89819 17.6363 9.44363 -21.9658 0.853712 16.3055 -393 2 7.88604 17.9611 8.38483 9.7933 6.77297 -11.9047 -394 1 4.50916 14.5069 3.91348 -1.14645 -26.1805 -53.139 -395 2 4.48781 15.3883 4.18695 -0.715057 47.311 12.47 -396 2 4.59583 14.0061 4.68593 4.03467 -28.7439 39.2156 -397 1 14.2649 7.40032 15.8248 -22.801 -12.9293 -21.4811 -398 2 15.1988 7.32934 15.7188 25.9215 -1.64325 -3.33443 -399 2 14.1282 7.83404 16.6492 -0.714938 9.98648 22.5393 -400 1 3.02257 18.338 1.93829 -9.63799 -32.7056 -36.1055 -401 2 2.55646 17.7535 1.2554 15.187 19.9859 31.9951 -402 2 2.37728 0.279403 2.32429 -11.6166 9.08866 3.80637 -403 1 7.9856 1.63208 4.58686 -21.2194 7.37107 -10.8429 -404 2 7.46714 2.08087 3.89599 -2.9365 -3.17783 11.7342 -405 2 8.82293 1.5175 4.16848 19.7493 -4.53145 -2.81354 -406 1 2.46603 14.1528 17.6814 26.4379 24.7021 -16.3984 -407 2 1.84119 13.6421 18.1459 -27.3849 -25.1212 16.5566 -408 2 3.3203 13.7773 17.9154 6.17156 -2.74614 2.81365 -409 1 0.847673 1.77812 13.8995 -29.1857 4.71799 7.40329 -410 2 0.70153 1.57851 14.8469 9.71331 1.1605 -15.3576 -411 2 18.5888 1.96886 13.5517 20.2657 -3.94578 7.10705 -412 1 4.44078 18.6823 13.9019 -16.0244 4.84661 7.61196 -413 2 5.30649 18.3093 13.8135 20.8517 -5.19628 -2.25594 -414 2 4.21344 18.5423 14.8331 -2.2181 0.553195 -4.50589 -415 1 7.17333 0.707602 18.3659 18.5924 -14.7376 -19.2949 -416 2 7.29313 0.222373 17.5065 -5.17699 16.3575 23.4569 -417 2 6.28409 1.05221 18.4099 -11.4153 -0.902781 0.0516699 -418 1 16.0458 18.3995 13.9929 19.922 2.02833 15.0786 -419 2 15.1358 18.307 13.8248 -34.099 -5.52537 -15.9309 -420 2 16.0494 18.5146 14.948 8.19193 5.7614 4.60276 -421 1 10.1078 4.56818 16.2539 38.806 25.935 -8.65561 -422 2 11.0636 4.83663 16.0361 -35.078 -16.4147 14.4025 -423 2 10.0818 3.61692 16.3176 2.43484 -11.3153 -3.34335 -424 1 15.9163 17.7591 4.46968 32.0074 -29.6155 -15.1132 -425 2 16.5099 -0.143617 4.50341 7.95185 14.4383 0.237761 -426 2 15.1003 18.0575 4.79025 -43.3278 16.7712 13.4837 -427 1 7.00774 17.4246 13.8321 -56.0949 -7.97771 -22.4327 -428 2 7.49162 17.6994 14.5684 25.5375 13.311 41.1471 -429 2 7.64463 17.2266 13.1734 23.6351 -3.93018 -21.4132 -430 1 13.2756 6.47326 6.61789 23.4956 20.1255 -14.8261 -431 2 14.0898 6.99784 6.40679 -18.3755 -16.6425 15.9473 -432 2 12.9103 6.33261 5.73881 -7.54238 -3.20295 2.17295 -433 1 7.79764 2.32743 9.30513 0.620653 -0.611916 41.3127 -434 2 7.26457 2.16571 10.1169 11.5422 6.28076 -11.6799 -435 2 7.22158 2.07024 8.60986 -14.5852 -6.72752 -26.4814 -436 1 15.1722 14.8472 13.687 6.75051 -12.1688 -2.41191 -437 2 14.9232 15.197 14.5358 -2.94711 1.82763 14.9216 -438 2 14.8185 15.4404 13.0388 -8.36185 8.62669 -11.0165 -439 1 9.38377 8.31795 3.7734 -21.5197 15.3047 -10.1967 -440 2 10.1883 8.66352 4.14356 14.5642 4.86611 3.27566 -441 2 9.4002 7.3753 3.8765 5.94621 -16.0238 5.03493 -442 1 17.77 13.5913 16.4331 -7.58631 -31.5789 18.0626 -443 2 16.8485 13.2919 16.3991 0.887673 4.05725 -0.920823 -444 2 17.783 14.4232 15.9937 -0.095827 22.773 -14.6224 -445 1 4.93053 10.5741 2.80353 -17.5831 18.6377 -10.1976 -446 2 5.6584 10.2884 3.33403 15.5926 -12.1878 10.3648 -447 2 4.56303 11.3186 3.30761 3.36544 -9.45409 -4.10473 -448 1 3.72361 8.36764 10.1215 3.29328 14.9495 -8.98506 -449 2 3.89363 9.29817 9.8724 -2.16289 -13.6958 -0.787578 -450 2 3.61222 8.39575 11.0685 -3.0862 -1.08413 10.2171 -451 1 15.9739 6.97387 6.06952 -13.2047 20.7109 0.201327 -452 2 16.7663 7.43242 6.33309 11.9845 5.69104 3.28059 -453 2 16.2425 6.10629 5.81378 6.71976 -25.6546 -0.898294 -454 1 15.1226 7.10933 9.08497 -8.54326 -39.6564 44.8588 -455 2 15.7377 7.52152 9.6861 12.0306 8.12876 4.18876 -456 2 15.1451 7.58697 8.30383 2.04885 32.3579 -51.8464 -457 1 6.29947 12.9646 12.7695 3.37722 -4.66482 -6.66232 -458 2 7.17165 12.6249 12.9809 1.24175 -10.0492 1.61343 -459 2 6.12977 13.6114 13.4445 -6.34808 15.4581 9.54933 -460 1 12.1164 4.51054 13.0962 -37.6646 -34.1548 1.17408 -461 2 12.2607 4.59773 14.0409 7.03003 6.16295 4.50476 -462 2 11.318 3.89029 13.036 30.5495 29.2935 -6.64922 -463 1 11.3767 8.15056 7.89733 -18.501 8.72492 -14.0328 -464 2 11.9999 7.57003 7.45959 11.3303 -6.40222 -0.944592 -465 2 11.6722 8.28384 8.79215 9.56916 -2.23029 14.0742 -466 1 17.1624 10.8628 7.5038 -34.939 16.2827 29.0255 -467 2 17.7665 10.1757 7.31962 29.6392 -23.074 -13.6235 -468 2 17.1223 11.4937 6.79065 1.17945 1.22203 -15.4432 -469 1 5.28569 18.1322 10.989 31.979 0.201705 -2.44437 -470 2 4.81806 17.865 11.7612 -14.4656 -7.34411 17.8618 -471 2 4.63582 18.2948 10.3295 -20.6991 2.34913 -21.9288 -472 1 7.59755 17.5197 1.78957 -4.56355 -5.70379 -23.6831 -473 2 7.90081 16.7255 1.29504 -6.23989 15.492 10.1621 -474 2 7.18064 18.108 1.12072 15.1074 -6.58967 11.1205 -475 1 1.93009 12.8809 13.5782 -3.15102 -7.76664 -18.9393 -476 2 1.45787 12.3423 14.2065 -6.90584 -5.9659 9.51664 -477 2 2.19823 13.666 14.0335 5.43227 17.0545 14.7464 -478 1 9.58089 6.76558 14.8178 3.72821 -35.8509 -10.9213 -479 2 9.75861 5.80832 15.0417 -6.66727 32.4051 0.0155959 -480 2 9.77461 6.83059 13.8656 0.408011 6.2359 8.07479 -481 1 15.2957 4.27102 10.7659 9.27088 14.9202 31.1326 -482 2 16.1322 3.95288 11.1528 -7.49935 1.06904 -21.0932 -483 2 15.0846 4.9939 11.387 -3.9034 -8.13187 -14.3813 -484 1 11.2455 6.18064 0.162868 26.0255 26.7031 14.5737 -485 2 11.4763 5.37121 18.3763 -4.81733 -21.4086 -8.3593 -486 2 10.308 6.3098 0.211594 -20.2553 -5.22819 -8.60243 -487 1 0.00824002 11.3791 15.0352 26.3856 -8.14992 32.1511 -488 2 18.096 11.5216 14.3022 -25.0888 8.62779 -34.0528 -489 2 -0.201285 12.127 15.606 2.8625 2.75044 1.90901 -490 1 7.02689 9.25213 7.27678 19.2929 16.5016 -4.78745 -491 2 6.59278 8.51389 7.67295 -14.5933 -20.8184 8.5158 -492 2 7.9603 9.00351 7.26624 -3.73747 1.30273 -1.02295 -493 1 18.3276 15.3446 12.3362 -3.78489 -4.33158 3.75643 -494 2 0.608087 15.5074 12.1532 11.0792 5.95639 -3.98767 -495 2 17.812 15.8736 11.72 0.968766 1.6464 -4.64437 -496 1 16.5183 4.40219 5.2766 -9.25512 24.5768 -59.2644 -497 2 16.7942 3.98653 6.05327 18.9035 -16.7679 44.3388 -498 2 17.2936 4.55111 4.6869 -10.7937 -7.24122 14.527 -499 1 17.7074 3.16435 10.7411 -7.07567 -19.8863 -1.17515 -500 2 18.5775 3.40914 11.0222 18.8337 10.6004 6.41913 -501 2 17.8312 2.27039 10.3862 -7.09349 4.4518 -2.20884 -502 1 12.3002 -0.0151335 10.1074 11.0606 -47.8945 -14.4391 -503 2 11.4203 0.251866 10.2671 -34.8312 14.3717 9.25421 -504 2 12.8296 0.729107 10.2725 26.3435 36.9272 6.71278 -505 1 10.377 9.78 12.4264 -19.0889 -11.9366 -11.7107 -506 2 11.0349 9.79085 13.1125 14.2042 0.527855 9.4859 -507 2 10.1856 8.83311 12.286 4.63513 11.4958 0.11243 -508 1 0.612468 2.80552 7.03105 -3.16196 -18.6605 -12.6623 -509 2 0.888173 3.44011 7.68312 3.89236 7.11247 14.3448 -510 2 0.935234 1.94488 7.34043 -2.08916 10.0979 2.30791 -511 1 0.333274 15.3197 6.88029 -14.1577 45.9776 55.0939 -512 2 0.45846 14.8119 7.69617 1.50982 5.91417 -3.14315 -513 2 0.483825 14.7581 6.18064 16.8578 -51.3136 -47.9608 -514 1 17.0479 7.0004 15.1603 7.32733 3.15391 4.0553 -515 2 17.7743 7.62519 15.0492 -4.65368 3.90748 -3.79045 -516 2 17.4843 6.26113 15.5911 -6.30626 -9.6282 -1.63315 -517 1 9.09335 12.4409 8.06571 39.5186 -12.5139 -7.54936 -518 2 9.34597 11.7249 7.45783 10.9221 9.9246 5.15013 -519 2 8.17581 12.4072 7.99758 -53.4732 7.6014 3.58329 -520 1 1.26136 1.81045 2.95361 -2.6705 2.40839 8.80735 -521 2 0.548126 2.01955 2.35817 -5.69651 1.92544 -13.4687 -522 2 1.50342 2.66138 3.33407 8.35517 -3.762 3.05283 -523 1 4.10861 15.1005 9.87028 17.6559 -3.6711 -5.25272 -524 2 3.99986 15.4157 8.96812 -4.49733 0.314881 -1.79245 -525 2 5.04559 14.8362 9.90181 -11.0653 1.71965 6.05025 -526 1 7.3044 2.18074 14.6544 -4.4599 -5.38687 1.90914 -527 2 7.13921 1.65822 13.8561 -1.41133 5.62984 3.30149 -528 2 7.58548 3.05039 14.3636 5.58134 3.87352 -5.39735 -529 1 18.5311 14.6245 2.16796 -28.4168 7.73599 -0.688338 -530 2 0.75601 15.0339 2.21782 2.27339 5.70314 -0.294719 -531 2 17.8249 15.3246 2.17516 22.0369 -13.9852 -0.651534 -532 1 9.98569 2.74939 12.8982 -9.19221 10.3282 12.793 -533 2 9.83979 2.05829 12.2602 3.07064 -9.86428 -11.8695 -534 2 9.16543 3.26718 12.8794 9.24196 0.527571 1.01071 -535 1 2.93657 8.90297 13.0427 17.8365 13.1008 0.527628 -536 2 3.20967 9.8454 12.9227 -4.18066 -20.4527 0.554358 -537 2 3.74278 8.43516 13.3493 -16.2822 5.83343 -3.94486 -538 1 3.21464 8.50963 3.72772 0.0178718 14.8284 -74.1155 -539 2 3.59865 9.33251 3.32895 -6.0017 -25.5341 4.84747 -540 2 3.33657 8.62148 4.62381 5.38554 5.83243 67.2306 -541 1 5.61344 7.20035 8.58446 -2.8239 -8.19112 0.0562215 -542 2 5.53456 6.24006 8.54079 8.61958 1.67382 -4.34837 -543 2 5.04066 7.41711 9.32304 -1.21443 9.5719 0.536432 -544 1 14.8964 1.44105 1.93253 -7.61412 -10.5809 19.4064 -545 2 14.4541 2.19461 2.37874 12.2686 -5.42452 -16.4906 -546 2 15.2548 1.628 1.06483 0.86569 15.045 -4.43663 -547 1 8.4154 15.1546 0.810786 1.70028 1.58395 -11.225 -548 2 9.17382 15.0707 1.40016 -1.99176 -3.13146 6.02583 -549 2 7.70673 14.5929 1.15135 2.54266 -0.476233 4.63029 -550 1 15.567 1.36482 7.20444 28.1778 15.3746 16.2283 -551 2 15.0185 0.765154 6.74682 -23.3742 -21.8939 -17.7163 -552 2 14.9729 1.99808 7.60632 -6.19001 12.1291 -0.330309 -553 1 5.0089 13.0207 18.4853 -18.4609 -5.74542 -15.9738 -554 2 5.42479 13.0864 0.690362 9.95106 2.52519 17.0862 -555 2 5.65544 13.3331 17.8473 1.85993 1.51979 0.712767 -556 1 15.3671 8.54929 18.1095 -8.15636 -15.968 22.0227 -557 2 15.6817 9.03573 17.3686 11.3034 18.5085 -22.2724 -558 2 15.31 9.18561 0.190372 -2.38163 -0.236806 -1.34825 -559 1 12.0802 3.07221 18.3457 4.60183 -13.894 -6.42275 -560 2 12.4859 2.4 0.260392 -4.96838 8.65649 13.1594 -561 2 12.2775 2.7013 17.4791 -3.58827 6.63097 -2.22236 -562 1 13.1993 12.6855 5.15579 5.61247 -4.39703 15.9491 -563 2 13.8115 11.9693 4.94018 -5.07495 0.365899 -6.13845 -564 2 13.2564 12.743 6.12308 -1.32671 2.90452 -5.88021 -565 1 6.08204 7.19061 0.120725 -6.90673 14.7019 -8.65455 -566 2 5.87336 8.13986 -0.0835188 5.89552 -25.7895 13.7146 -567 2 5.2676 6.79179 0.465292 5.04542 5.75855 -0.526985 -568 1 17.7014 15.9063 14.9696 22.6091 -4.25312 7.62853 -569 2 16.8618 16.3646 15.0156 -4.32677 -2.50983 -14.3551 -570 2 17.9392 15.6583 14.0532 -15.4152 10.9643 9.19951 -571 1 13.1673 0.955706 16.6058 -16.4624 13.9879 0.0318296 -572 2 14.0199 0.765403 16.9805 16.2653 -3.85138 1.37902 -573 2 12.7278 0.106773 16.5459 -0.203322 -8.12911 -4.60325 -574 1 10.9967 14.5844 7.33958 -18.0316 -21.646 7.99268 -575 2 10.1705 14.1548 7.70673 29.6081 10.2394 -10.7243 -576 2 11.7328 13.9554 7.47718 -10.5059 7.23567 0.829732 -577 1 17.5629 8.52802 2.09087 -9.01192 -26.3923 -8.78708 -578 2 16.6633 8.41226 2.4486 12.6056 4.50253 0.467713 -579 2 17.6588 7.73531 1.50133 0.834193 24.7006 12.2923 -580 1 12.3809 7.87992 1.9744 6.05515 -15.9846 -5.53898 -581 2 11.7749 8.59773 2.10936 -4.35558 14.0343 4.46215 -582 2 11.9629 7.32605 1.30246 4.89043 0.565697 0.45699 -583 1 11.9793 14.6347 10.4335 18.2405 9.923 28.253 -584 2 12.2756 14.1199 9.71871 15.2703 -21.0335 -29.0838 -585 2 11.0615 14.7405 10.2767 -32.5541 7.66631 -1.56623 -586 1 6.81522 6.956 15.5295 -17.6641 -14.7432 -7.98444 -587 2 7.71149 6.86909 15.2553 24.3623 -4.30517 -12.3513 -588 2 6.87971 7.6292 16.1782 -5.40685 18.4787 21.7047 -589 1 8.03389 4.5887 13.4155 -37.171 -3.64226 -22.5123 -590 2 7.25568 4.78495 12.82 23.9185 -7.87368 18.6792 -591 2 8.43341 5.43391 13.5743 6.319 9.72574 1.79505 -592 1 13.4002 12.1853 14.3374 -4.54681 1.91445 -1.84351 -593 2 13.053 11.3082 14.1695 -1.05297 -9.08012 2.89826 -594 2 13.8525 12.4201 13.5231 2.34057 5.70396 -2.70792 -595 1 14.6576 9.49709 7.25838 9.71531 18.8932 28.1379 -596 2 15.5128 9.94191 7.46983 -15.999 -8.53149 -8.43731 -597 2 14.0596 9.76702 7.98865 8.11873 -7.0154 -18.3951 -598 1 12.7312 16.9238 3.19475 21.2814 -46.1617 -18.4213 -599 2 12.8913 17.1254 4.09275 6.71284 11.8391 31.6773 -600 2 12.0991 17.5238 2.88672 -32.0955 36.7838 -15.6883 -601 1 1.05963 7.10571 17.4007 12.4792 -13.0695 22.2141 -602 2 0.186546 7.34268 17.7101 -8.13154 -6.52047 1.59159 -603 2 1.15324 7.46505 16.5336 -1.37945 14.6986 -20.6467 -604 1 12.8789 5.0234 15.6828 -31.729 4.63914 -0.239626 -605 2 13.551 4.37036 15.6981 25.2388 -22.1242 0.0408259 -606 2 13.353 5.8465 15.7229 6.14669 17.5754 0.411177 -607 1 2.40704 3.36861 5.12193 5.52974 -41.8871 -53.5671 -608 2 1.82145 3.26591 5.8288 -30.6852 -8.64892 41.0269 -609 2 2.78115 4.20498 5.20734 26.4804 50.2953 11.9131 -610 1 8.27515 11.124 13.5771 -2.85187 11.2881 -70.0801 -611 2 8.37295 10.8581 14.431 -1.92558 -15.2628 85.0569 -612 2 8.99363 10.6344 13.1748 6.72692 3.2721 -14.9 -613 1 12.918 1.48119 13.2724 -5.46048 -28.9446 23.2516 -614 2 13.637 1.39783 12.6661 14.6279 -0.945194 -20.1211 -615 2 12.6406 2.36931 13.1901 -10.8983 31.3672 -5.19186 -616 1 6.50945 13.6334 2.15016 9.54562 -3.73103 -23.7728 -617 2 5.85792 13.9589 2.75542 -11.9505 6.96003 17.098 -618 2 7.07728 13.0286 2.63475 0.813075 1.46302 3.43305 -619 1 15.9192 6.52891 12.704 16.1802 17.7634 -8.70325 -620 2 16.3422 7.10874 12.0232 -9.40583 -17.3352 17.4966 -621 2 16.4304 6.67694 13.5293 -11.6709 -4.5663 -12.9766 -622 1 16.8012 0.7168 9.58424 5.37965 28.6432 5.104 -623 2 16.9134 18.4317 9.69441 -4.13374 -28.9785 4.85106 -624 2 16.4797 0.860059 8.69243 -6.31121 -1.15561 -8.50241 -625 1 6.13999 11.6637 8.32406 3.84263 60.0529 3.8669 -626 2 5.34748 11.493 8.80779 -22.31 -6.18549 9.45125 -627 2 6.46273 10.8378 8.08078 19.7827 -51.2376 -16.1138 -628 1 2.82548 8.7059 0.356008 25.1404 7.14145 17.7175 -629 2 2.1872 8.20684 18.5458 -21.47 -27.2684 -27.7438 -630 2 2.28201 9.37487 0.754925 -1.41085 15.0233 10.6798 -631 1 10.1039 10.4509 6.57992 -4.79526 -6.25674 7.70278 -632 2 10.5083 9.74309 7.09516 2.94215 -0.723708 0.948173 -633 2 10.6276 10.5201 5.78606 4.97834 -0.717699 -12.6856 -634 1 6.77313 15.7547 6.63388 -5.578 -17.4503 -5.92282 -635 2 7.15743 16.0375 7.46176 7.11582 8.10879 3.23091 -636 2 7.28529 16.1142 5.89948 -1.84538 11.4125 4.1387 -637 1 6.44197 13.0281 5.69829 11.2984 8.90971 -1.05733 -638 2 6.79679 13.8886 5.97631 -5.91305 -5.55439 0.155281 -639 2 6.12445 12.6032 6.49753 -3.74834 -3.51916 3.00547 -640 1 16.7803 12.5246 9.7433 1.48678 16.9805 10.4147 -641 2 16.9869 12.0132 8.97443 1.49858 -19.0548 -12.8116 -642 2 17.3026 13.3224 9.61445 -4.02823 0.499055 5.20393 -643 1 6.14077 2.94238 2.79674 5.90568 12.9134 -1.15866 -644 2 6.37771 3.87334 2.54509 -6.86675 -27.0997 0.367621 -645 2 5.77601 2.45475 2.03942 1.6023 9.98348 0.439644 -646 1 10.8329 3.18005 3.24633 -5.48645 -3.34604 -3.46544 -647 2 10.1887 3.87164 3.40992 -1.49044 3.74393 4.82403 -648 2 10.5052 2.73309 2.45537 3.4248 -0.0323397 2.60803 -ITEM: TIMESTEP -60 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.78901 6.89398 17.9776 -3.5234 1.93788 3.89787 -2 2 7.91305 7.05712 18.3419 -1.4277 0.241332 2.63834 -3 2 8.67661 6.15674 17.3832 1.3639 -6.15529 -7.04239 -4 1 18.7561 8.31771 6.77309 10.5748 -7.50476 -33.4266 -5 2 0.457617 7.9886 5.89382 -17.7288 16.9324 23.762 -6 2 0.568724 7.76979 7.40723 1.86737 -7.24646 12.6232 -7 1 8.51532 18.7703 6.84705 0.662358 -5.68449 9.56329 -8 2 9.4329 0.211311 6.58737 4.53489 1.21926 -2.36791 -9 2 8.05203 0.803554 6.35578 -1.87482 6.91549 -4.54998 -10 1 6.50103 1.76445 11.707 -23.9337 -6.76257 7.94266 -11 2 5.68898 2.17855 12.0897 23.4576 -7.00878 -10.5629 -12 2 6.21872 0.874053 11.3985 3.54415 20.4784 6.13886 -13 1 7.00577 5.62696 2.40487 20.8008 -18.6778 -13.9491 -14 2 6.3381 5.93149 2.99593 -12.7158 11.2498 18.9927 -15 2 6.96044 6.19487 1.63998 -3.33571 5.44078 -9.1088 -16 1 16.2317 10.2379 16.0906 -2.65398 7.02849 4.45196 -17 2 17.1094 10.623 16.0697 3.52116 -7.47169 -6.62031 -18 2 15.6835 10.996 16.3292 -1.12895 -7.31017 -0.603728 -19 1 10.664 14.9341 2.30567 13.0251 3.56406 6.3158 -20 2 10.7336 14.2976 3.03428 -5.34804 6.23285 -3.50086 -21 2 11.2229 15.6743 2.58509 -4.07292 -1.48419 -0.585019 -22 1 17.1728 8.23947 10.7128 -1.64499 -1.99855 0.608593 -23 2 16.6728 8.84067 11.2819 0.316783 0.889357 -0.63917 -24 2 17.9322 8.74349 10.3965 1.71935 0.329185 -1.07247 -25 1 14.697 15.9473 16.4368 -13.7705 -0.197196 -7.11694 -26 2 13.7879 16.279 16.3001 13.6207 -4.8592 3.02749 -27 2 14.6438 15.4158 17.2461 5.07545 7.5417 -4.99128 -28 1 12.1134 13.367 0.528093 -6.39608 9.01831 -4.72995 -29 2 11.8173 13.4954 18.2644 6.74141 -8.66363 -5.87361 -30 2 11.5587 13.987 1.01769 3.38254 -3.71164 8.60635 -31 1 9.30318 5.47999 3.94883 35.8178 1.45581 -2.5285 -32 2 8.76671 5.2044 4.67379 -16.9173 -4.15595 18.9992 -33 2 8.71572 5.58687 3.21666 -20.2172 1.55363 -14.8227 -34 1 1.70529 4.08306 11.601 -3.00308 -9.11056 -2.97947 -35 2 1.52513 4.97184 11.9147 2.37337 9.05749 0.600173 -36 2 2.22567 3.63839 12.2786 -1.82607 -0.283286 1.9059 -37 1 2.04499 6.82744 8.26893 9.18028 14.0429 7.96475 -38 2 2.5896 7.29904 8.93262 -11.3816 -6.25496 -6.31442 -39 2 1.81536 5.98181 8.67357 4.33854 0.450625 -3.71013 -40 1 5.3656 4.4774 7.93824 1.44041 9.72132 7.59831 -41 2 5.44269 3.52851 7.84762 -1.19648 -12.0175 -6.62376 -42 2 4.92598 4.83778 7.16432 -9.0894 -3.97332 -7.9273 -43 1 3.32251 2.9413 17.4443 0.538374 -34.3486 -6.77872 -44 2 3.98642 3.24962 16.8336 8.9197 7.73227 -3.39959 -45 2 3.04976 3.68399 17.9526 -12.2781 23.4468 13.5982 -46 1 7.437 5.38423 6.13063 5.01567 -0.272219 -26.6536 -47 2 7.97737 5.94965 6.66546 10.8347 10.076 12.8667 -48 2 6.99068 4.78917 6.71033 -9.3836 -11.0864 17.8628 -49 1 9.80479 7.01238 12.0379 -9.46641 4.39554 -21.4508 -50 2 10.3276 6.40912 11.4906 -4.30802 3.34771 7.14548 -51 2 9.13044 7.38666 11.4225 10.4612 -8.54147 15.485 -52 1 14.0024 3.65677 8.07153 1.90613 10.1899 13.6881 -53 2 13.9361 4.48059 7.56554 -1.4656 -7.0627 2.39316 -54 2 14.1946 3.93561 8.9889 0.417494 -3.38136 -15.0381 -55 1 4.51888 17.1453 3.95588 7.87944 -4.67708 3.20643 -56 2 5.41436 17.4585 3.90856 16.3959 1.38908 8.05638 -57 2 4.13204 17.4705 3.15493 -16.1768 7.51082 -11.5461 -58 1 16.4506 16.6012 10.3314 -28.9812 -6.12917 4.01051 -59 2 15.5905 16.5574 10.8183 20.4446 2.48532 -11.9951 -60 2 16.2667 16.1387 9.49338 0.364513 2.67256 9.91326 -61 1 1.97065 4.79938 0.260671 -8.10245 -17.5737 -13.0373 -62 2 2.41281 5.12274 1.03667 10.218 10.6244 9.40508 -63 2 1.8267 5.54768 -0.321227 -3.59337 9.6389 -0.147197 -64 1 11.5035 13.2586 16.3577 -0.713967 20.2415 12.8794 -65 2 11.0441 12.4305 16.4814 -6.19498 -9.28579 -2.23027 -66 2 12.0754 13.1484 15.6021 5.65191 -4.41955 -9.63321 -67 1 10.1276 11.0105 16.8449 -6.46201 16.5427 1.83518 -68 2 10.5556 10.1721 16.794 12.0656 -22.7421 -1.13044 -69 2 9.20289 10.8171 16.6996 -9.212 1.56961 -0.130134 -70 1 11.787 17.4505 13.4822 -3.74088 11.88 -4.97071 -71 2 12.2373 16.9277 12.8063 6.56705 3.4706 4.72845 -72 2 12.0251 18.3805 13.3063 -1.30808 -7.68873 2.97322 -73 1 6.42132 9.37259 12.2366 13.1698 8.24141 3.19081 -74 2 6.99069 9.01867 11.5406 -12.3498 -0.982732 4.41902 -75 2 7.03807 9.88277 12.7853 -8.70879 -2.27031 0.0855326 -76 1 16.2815 12.8722 2.70224 -2.02351 7.50879 0.830271 -77 2 17.1172 13.3658 2.56775 -16.1548 -5.18742 1.80773 -78 2 15.5334 13.5108 2.69253 18.3367 -6.33955 1.64103 -79 1 0.729913 12.6587 5.89268 5.90957 5.27776 3.54404 -80 2 1.01336 12.4973 4.99287 4.32656 -0.558571 -7.43154 -81 2 18.4322 12.7877 5.81211 -15.2269 -3.44557 0.704235 -82 1 5.2582 16.4249 18.4194 -10.384 10.1199 -1.35479 -83 2 5.6864 15.6785 18.0038 6.48963 -9.24773 3.62069 -84 2 5.52942 16.4885 0.694307 6.00107 -3.50652 -0.438993 -85 1 0.618748 7.72132 4.16911 -57.0293 -28.7954 36.7096 -86 2 18.6577 8.06272 3.52122 -10.6934 7.30065 -13.2418 -87 2 1.44908 7.88182 3.83946 68.942 18.8036 -26.9673 -88 1 3.13476 8.97804 6.4725 9.50813 11.9402 -13.0637 -89 2 3.74054 8.49646 7.01761 11.8689 -6.06991 10.2621 -90 2 2.28514 8.86225 6.86989 -19.244 -2.30506 4.89646 -91 1 7.29998 10.3842 16.2581 17.8205 -0.109318 -17.8263 -92 2 6.62843 10.5749 15.608 -5.58859 2.04705 -1.34953 -93 2 6.87201 10.3756 17.1052 -6.43011 -2.48695 12.6131 -94 1 11.0863 0.954938 5.00203 0.851153 5.26347 3.05665 -95 2 11.191 1.83687 4.62341 -3.02583 0.75042 -0.451702 -96 2 10.8235 0.406956 4.25776 -2.05383 -4.79736 -1.16032 -97 1 4.33613 2.85707 13.1911 1.54519 27.1095 -5.33994 -98 2 4.57692 3.1724 14.0657 0.352889 6.79614 0.336856 -99 2 4.2364 1.93118 13.308 -7.70759 -34.1778 4.58716 -100 1 8.4203 10.2079 1.80876 2.06346 -1.14808 -20.454 -101 2 8.303 10.9031 2.4489 -3.41662 7.51624 10.9075 -102 2 8.71506 9.44854 2.30018 2.97787 -12.0816 9.03727 -103 1 10.3977 1.70625 15.5267 1.73644 2.79304 1.06494 -104 2 11.3647 1.6343 15.5026 -8.09264 -2.44943 -3.11689 -105 2 10.0867 1.93234 14.6348 6.55478 -0.658466 2.12488 -106 1 2.65181 12.9273 7.85805 -0.311785 2.06689 -1.07798 -107 2 3.23228 13.5447 7.39928 3.74905 0.741997 1.40009 -108 2 1.98379 12.6968 7.20259 -0.999427 -0.794231 1.07688 -109 1 3.77953 11.641 5.00453 4.18201 7.36008 7.19136 -110 2 3.61117 10.803 5.43181 -1.00449 -4.29555 7.12479 -111 2 2.98088 11.8656 4.52857 -4.84381 -0.0516249 -5.594 -112 1 6.70671 14.4383 16.9441 -2.88793 7.65462 4.66357 -113 2 7.46032 14.9632 17.2378 1.25427 -2.15328 -4.6823 -114 2 6.29331 14.8741 16.1864 7.83964 -2.53039 -3.71142 -115 1 14.1974 14.5272 3.32557 -8.64957 0.126228 1.77541 -116 2 13.6145 15.2324 2.99689 6.18241 -4.15847 9.95625 -117 2 13.7792 14.1343 4.11346 2.7139 4.36583 -10.9531 -118 1 8.49626 18.0895 16.0579 -56.9361 5.6973 -1.31016 -119 2 8.97799 17.2887 16.1101 31.3098 -20.0295 7.70991 -120 2 8.99116 0.248943 16.0582 28.7181 13.2998 -3.6499 -121 1 4.72072 1.70195 4.90499 9.17194 -24.9679 14.1726 -122 2 3.98364 2.22531 5.16555 -23.8501 10.7625 5.04957 -123 2 5.10611 2.17516 4.19081 15.0133 13.348 -19.3674 -124 1 15.0233 12.5839 16.4881 -18.3113 17.2758 -0.569629 -125 2 14.531 13.0978 17.1312 10.6463 -2.17552 11.3526 -126 2 14.3728 12.5238 15.7796 8.99848 -7.00837 -8.88439 -127 1 15.6995 18.4783 16.8755 -18.8856 10.9503 -24.4051 -128 2 16.4938 18.4127 17.3644 26.3461 0.942046 24.9737 -129 2 15.418 17.5728 16.7613 -4.49112 -11.2036 -1.17338 -130 1 1.28835 1.23059 16.5761 -5.93248 -0.138309 0.14802 -131 2 2.13994 1.64325 16.7078 7.79309 6.58334 -0.470261 -132 2 0.740967 1.66098 17.2372 -5.253 -1.12337 3.85618 -133 1 18.1629 4.44327 15.9115 -6.79632 -1.27318 -1.28488 -134 2 18.1308 3.86521 15.1462 0.0573414 -0.0912133 -1.44422 -135 2 0.437875 4.54116 16.1499 5.78898 1.89854 1.50737 -136 1 12.2373 17.0002 16.1546 0.545523 9.79929 -13.3931 -137 2 11.4461 16.6427 16.5433 -11.0844 -6.7728 9.10484 -138 2 12.011 17.1373 15.2222 3.0182 -2.09591 3.06353 -139 1 16.0678 2.55904 18.1722 10.2246 -6.29614 14.7907 -140 2 15.8342 3.46829 18.3235 -8.81825 14.1289 4.59946 -141 2 15.8732 2.39245 17.2622 -4.4601 -2.08833 -19.809 -142 1 6.72425 13.805 10.1648 -2.60578 6.66979 -6.33116 -143 2 6.49371 13.5045 11.0525 -0.564993 -6.25943 -2.37403 -144 2 6.44263 13.1457 9.51237 3.71898 -2.3263 8.04067 -145 1 10.1796 18.3897 2.72456 -2.84724 -9.82946 6.47371 -146 2 10.454 0.395639 2.08514 4.83004 8.04726 -9.16723 -147 2 9.37175 18.0281 2.35385 -6.15379 0.681222 3.71385 -148 1 3.03584 17.7169 6.12875 -8.09623 -9.32203 -7.45056 -149 2 2.18289 17.4189 5.74043 17.1828 11.6191 3.33552 -150 2 3.689 17.6882 5.40781 -11.2408 2.0569 5.59443 -151 1 12.6056 16.8615 7.96971 24.61 3.09247 -20.49 -152 2 12.0094 16.1192 7.91607 -18.906 -3.75998 3.49802 -153 2 12.4208 17.4479 8.69718 -9.87831 1.59818 13.2946 -154 1 14.8851 15.258 8.17849 4.86996 1.69705 3.53461 -155 2 13.9994 15.6489 8.25275 11.2692 6.96129 -5.86816 -156 2 15.346 15.6481 7.40987 -12.7499 -9.2219 7.50011 -157 1 17.7579 18.2305 0.335063 13.8809 -6.66068 -7.77561 -158 2 18.5388 17.6427 0.115787 -18.9695 29.962 7.44433 -159 2 18.0215 0.522838 0.460167 3.90753 -19.2563 -2.82208 -160 1 0.789759 10.4825 1.35847 3.51968 14.2812 -7.72333 -161 2 0.0798625 9.88631 1.6077 -6.45512 -1.46576 0.207918 -162 2 0.407025 11.2033 0.810215 7.48025 -15.8311 11.8414 -163 1 1.75759 12.251 3.36651 -3.2997 0.800224 -5.24767 -164 2 1.53389 11.5715 2.69671 0.947411 14.52 5.02147 -165 2 1.90006 13.112 2.93145 -3.03991 -14.1386 -4.6936 -166 1 0.626528 17.2392 4.94747 0.535799 -10.8391 4.53682 -167 2 18.8821 18.137 4.96158 -2.27873 -17.8214 11.6149 -168 2 0.354378 16.6324 5.68648 2.97307 28.5848 -17.7586 -169 1 1.10952 0.863641 9.39152 -13.7339 -4.40866 12.9037 -170 2 1.31873 0.587529 10.3088 -1.45288 2.90017 -16.0983 -171 2 0.209028 0.525909 9.24512 10.3392 4.25606 -0.349363 -172 1 16.7392 2.34887 13.3076 6.86896 9.31967 14.159 -173 2 16.9447 2.54868 12.3949 -1.60073 1.25233 -7.99088 -174 2 16.5723 1.40956 13.3727 -4.20045 -10.3799 -4.26178 -175 1 2.67499 15.8791 12.0838 -15.6649 13.6026 18.6328 -176 2 3.08767 15.4473 12.8331 1.25238 -1.62775 -1.314 -177 2 3.09072 15.5563 11.2931 8.09534 -6.35014 -12.1736 -178 1 16.4274 15.6453 6.10859 -17.0431 -16.804 0.948824 -179 2 17.3058 15.6768 6.44562 21.0308 -4.79075 10.9 -180 2 16.4023 16.3397 5.46924 -8.03031 15.1286 -15.2988 -181 1 5.80151 5.1106 11.8034 -9.99749 12.6805 7.50019 -182 2 5.41461 5.91177 12.2246 6.41162 -14.9692 -6.22456 -183 2 5.12172 4.42339 11.8362 4.25931 3.80702 2.95737 -184 1 15.1575 4.86793 0.802761 22.7174 4.42582 -27.0135 -185 2 14.9254 4.50834 1.64009 -5.31496 -5.26411 26.4075 -186 2 14.3858 5.30472 0.469017 -12.1413 5.82456 -3.82743 -187 1 16.3769 16.3844 2.01422 -5.72057 14.22 1.10565 -188 2 15.9278 16.7493 2.80314 10.8683 -6.01604 -9.24812 -189 2 16.773 17.1531 1.56448 -5.22082 -7.76197 3.40899 -190 1 0.23965 4.83003 3.84895 -16.8427 -30.7507 -16.2196 -191 2 0.252698 5.75131 3.99923 2.34384 38.0203 4.84997 -192 2 0.859131 4.45396 4.45569 14.7994 -7.19156 9.40612 -193 1 2.95205 15.0559 15.135 12.255 2.89982 -34.0079 -194 2 2.82691 14.77 16.0276 -6.33331 -2.96333 21.8089 -195 2 2.70057 15.9867 15.0833 -9.42631 -1.00353 7.2626 -196 1 1.12786 14.6523 9.50314 0.137917 -12.6668 4.07712 -197 2 1.90226 14.1941 9.14772 -4.18616 2.58129 -2.64264 -198 2 0.826039 14.044 10.1958 0.138103 8.11094 -6.03497 -199 1 13.5191 16.5585 11.5327 7.73147 -8.17374 8.97592 -200 2 13.1298 17.2703 11.0385 -2.21772 17.726 -8.86187 -201 2 13.0359 15.7976 11.2032 2.83922 -8.38127 -1.58332 -202 1 4.66669 1.44213 0.750789 16.1276 9.43437 -4.32571 -203 2 4.14083 2.03292 0.213208 -5.20243 5.56453 -6.36037 -204 2 4.0469 0.85314 1.17877 -1.04658 -3.40534 3.74731 -205 1 1.47829 18.5621 11.858 5.51121 1.25702 19.3245 -206 2 1.35114 0.550992 12.5892 2.53269 -8.70306 -5.34898 -207 2 2.06733 17.8728 12.2103 -6.7512 4.69931 -6.32602 -208 1 11.4685 10.1386 3.99675 -31.6511 -19.8648 40.1611 -209 2 11.3534 10.4173 3.11507 -1.88937 16.5167 -32.0622 -210 2 12.3922 10.1317 4.15588 31.92 0.339396 6.83567 -211 1 8.2329 12.185 3.6562 14.6677 -4.21505 -16.0366 -212 2 9.0609 12.5679 3.94713 7.11932 4.3628 2.52934 -213 2 7.63223 12.3212 4.36927 -17.6963 1.05811 24.4992 -214 1 14.5368 4.0151 3.29112 -13.123 -7.80297 -23.8392 -215 2 15.0981 3.94713 4.04639 13.729 3.5857 20.4451 -216 2 13.7669 4.51912 3.55347 -6.0046 4.6829 5.42155 -217 1 5.65486 1.65777 7.52148 58.4475 40.9395 -13.9317 -218 2 4.99661 1.25201 7.99959 -53.8788 -37.1346 38.2946 -219 2 5.51095 1.40377 6.61889 -5.49301 1.61126 -19.8188 -220 1 17.8901 1.045 4.84749 -9.94718 -16.9222 0.488244 -221 2 18.5122 1.52388 4.30334 5.34684 7.49098 -3.2278 -222 2 17.6047 1.57034 5.59464 4.63979 8.2364 3.24002 -223 1 6.81309 9.39039 4.50819 3.0131 -8.49785 6.19054 -224 2 6.80308 9.57416 5.46384 1.81054 -3.72037 -9.62081 -225 2 7.68859 9.02244 4.29465 -5.74329 4.97879 4.89484 -226 1 2.5752 14.8387 1.99973 -14.8295 0.871449 -1.75437 -227 2 3.26878 14.7632 2.65166 10.803 -1.54702 2.65568 -228 2 2.97003 14.8559 1.12279 1.99123 -2.02101 2.0261 -229 1 17.298 12.9204 13.1492 -3.4846 16.1956 -6.51124 -230 2 16.423 13.308 13.3278 8.68723 -6.18077 0.438899 -231 2 17.8438 13.7012 12.9334 -6.61166 -12.0077 2.21466 -232 1 14.9034 10.5534 1.40093 -1.35277 29.2651 19.5565 -233 2 15.388 11.3453 1.77149 -13.4573 -26.0533 -12.1606 -234 2 13.9634 10.6773 1.62965 16.0361 -2.08776 -5.28169 -235 1 5.72986 6.65162 4.58435 -17.0557 15.5593 -6.14164 -236 2 5.84842 7.61417 4.55049 3.33824 -4.32419 -0.681988 -237 2 6.28697 6.32726 5.29234 8.09232 -2.61709 -0.816212 -238 1 7.99944 8.35521 10.3848 17.9936 -2.63811 -6.27588 -239 2 8.59251 9.07404 10.0893 -6.48701 -11.154 -5.32581 -240 2 7.88909 7.71789 9.66296 -2.42609 11.6503 -0.200638 -241 1 13.4241 18.44 5.69275 23.5538 0.0525075 -9.71433 -242 2 12.6953 0.391603 5.53139 -12.0458 3.72648 -1.32391 -243 2 13.2482 18.017 6.52624 -8.74326 -11.7295 10.7578 -244 1 0.0158155 2.64508 0.27395 14.5716 -58.678 15.8132 -245 2 17.7841 2.79898 -0.0392974 -21.1138 14.4347 -10.6776 -246 2 0.56739 3.397 0.238244 13.7063 38.8805 -4.38724 -247 1 12.8888 11.0203 9.74081 14.4921 -25.5472 6.65601 -248 2 11.9442 11.0265 9.60333 -9.9467 -3.56544 -1.05488 -249 2 13.1018 10.1085 10.0646 -8.85698 19.3484 -7.35591 -250 1 0.676749 12.1402 11.0769 -15.7222 13.4662 19.3247 -251 2 18.361 12.1632 11.2371 5.51909 -2.16069 -8.49445 -252 2 1.03381 12.419 11.9274 8.68848 0.134808 -1.80861 -253 1 5.1281 7.32638 13.4074 12.574 7.81643 0.126088 -254 2 5.56178 8.11083 13.0117 -0.574951 -12.9077 2.36295 -255 2 5.67541 7.10745 14.1812 -7.25639 3.83801 -6.5213 -256 1 1.19691 6.83481 11.9192 5.63437 23.0857 0.0567084 -257 2 0.430704 7.22717 11.4609 12.0202 -4.44614 6.83847 -258 2 1.80476 7.59103 12.1282 -18.5438 -19.7012 -5.0003 -259 1 15.5112 9.6605 12.308 7.39931 -23.3592 2.14975 -260 2 15.3284 10.5626 12.1388 -11.1565 28.2269 -10.7029 -261 2 15.46 9.608 13.2546 2.72926 -7.26454 12.4411 -262 1 16.5981 12.7055 5.55132 5.93792 -6.99565 4.13948 -263 2 16.3871 13.6216 5.72312 -3.40713 11.8574 1.85996 -264 2 16.4508 12.5854 4.61105 -1.1211 0.407027 -8.19974 -265 1 6.341 9.80883 0.0188309 -5.87145 18.2236 11.3739 -266 2 5.58583 10.3592 0.271383 3.51693 -3.70717 1.01998 -267 2 6.97723 9.90576 0.746734 -2.19026 0.0209431 -7.09875 -268 1 12.2976 6.11648 4.05009 -7.99316 6.14403 -18.1211 -269 2 12.258 6.83685 3.38221 3.50754 -15.1435 11.6411 -270 2 11.4736 5.62673 3.91242 4.22123 1.1153 4.56647 -271 1 0.341758 12.8367 0.152932 -4.41368 -4.71323 -6.18075 -272 2 -0.071293 13.3938 0.818389 4.38543 6.64898 2.3316 -273 2 18.4831 12.9746 17.9873 -4.56942 3.87447 -1.94524 -274 1 3.61813 18.6313 8.61443 0.661139 8.76689 2.03667 -275 2 3.46056 18.3752 7.69711 -0.554223 -6.30588 2.24303 -276 2 2.77043 0.354615 8.90695 5.13325 -4.08936 -2.3138 -277 1 7.42355 17.3409 4.4768 -7.56741 1.42105 -0.716546 -278 2 7.51902 18.2689 4.68925 3.30463 5.13228 6.51734 -279 2 7.58206 17.32 3.5353 -0.521854 -4.80047 -8.50069 -280 1 9.24832 17.1301 12.2139 -13.1815 7.8308 -4.22869 -281 2 9.33905 16.301 11.7591 -2.0028 -14.1862 -9.75618 -282 2 10.0447 17.2202 12.718 16.3553 3.99578 13.5609 -283 1 13.2894 13.0415 8.03267 8.35671 10.0486 -9.41069 -284 2 13.3695 12.1786 8.4589 5.84428 6.69767 4.94138 -285 2 14.1604 13.5085 8.0433 -18.6948 -10.3528 3.9365 -286 1 14.8481 2.99092 15.3927 0.856118 4.40098 19.7153 -287 2 14.1706 2.3196 15.3374 -5.14829 -8.82459 -5.54141 -288 2 15.3789 2.92995 14.603 5.00888 -0.952448 -11.2281 -289 1 9.90287 15.5907 16.9887 3.86064 7.54266 0.708681 -290 2 10.4376 14.8321 16.7196 -3.05759 -5.14225 0.11478 -291 2 9.69704 15.4836 17.9287 -2.19155 -3.5869 -5.21272 -292 1 11.3068 8.44228 16.6046 -8.18504 -5.87812 -2.49231 -293 2 10.7375 7.86962 16.0559 4.371 7.7216 8.33293 -294 2 11.2933 8.06373 17.4959 1.16379 -1.60832 -8.83864 -295 1 4.00007 18.2264 16.7774 4.24494 10.2639 17.5421 -296 2 4.56172 17.6396 17.2965 -1.57319 -6.32646 -5.9019 -297 2 3.85664 0.302165 17.4089 -1.12143 -0.586814 -11.7526 -298 1 2.2479 4.22742 8.91978 -15.7964 -0.236851 -9.315 -299 2 3.17417 4.26053 8.71033 14.3134 -0.385935 -1.23962 -300 2 2.16897 4.01078 9.84529 1.80454 -0.809508 12.1296 -301 1 9.87751 10.3883 9.74788 10.9603 -30.3507 -6.41167 -302 2 9.55849 11.2198 9.44401 -12.062 25.9436 -6.06801 -303 2 10.0779 10.4258 10.6774 1.92757 5.46095 17.7276 -304 1 9.69765 0.927205 10.8701 14.9831 -0.992619 -3.75191 -305 2 9.43595 0.039964 11.1566 -10.0783 4.56951 -4.94264 -306 2 9.12787 1.25731 10.1583 -1.53115 -8.98556 4.28196 -307 1 9.19006 15.088 10.2066 22.8811 13.4843 7.03893 -308 2 8.82905 15.9231 9.90375 -5.23887 5.212 -7.88342 -309 2 8.4517 14.4971 10.2333 -16.9878 -12.2258 -0.936878 -310 1 0.910091 9.64474 10.2618 6.35784 -25.2235 -17.0921 -311 2 0.848571 10.4636 10.7331 2.68282 16.4495 1.28733 -312 2 1.6853 9.71195 9.67503 -11.8234 -0.16557 12.5577 -313 1 17.0493 4.85425 8.1315 23.124 -12.0189 -22.071 -314 2 16.5036 5.57379 8.38464 -19.6085 19.0848 9.20549 -315 2 17.0051 4.2127 8.82658 -1.69519 -7.20825 12.6053 -316 1 14.7684 14.7087 0.123438 -2.69691 -12.5371 -11.3918 -317 2 15.061 15.3506 0.758659 10.1685 10.0196 13.4831 -318 2 13.9556 14.337 0.462955 -8.28455 -4.39651 5.72223 -319 1 3.75153 11.0481 9.53582 4.71209 -10.2499 1.98044 -320 2 3.63189 11.3357 10.4456 -0.734234 5.70871 5.17654 -321 2 3.24354 11.632 8.96907 -2.43681 8.8531 -2.47663 -322 1 11.2519 10.7463 1.5017 8.48932 -12.5201 -0.266865 -323 2 11.5908 11.5519 1.12329 1.64528 14.0457 -7.10687 -324 2 10.3311 10.688 1.26079 -12.3399 1.77059 -3.9568 -325 1 13.1496 7.17281 12.6854 5.50111 -7.8338 2.87732 -326 2 14.101 6.95885 12.7444 -10.2033 1.82309 -0.47089 -327 2 12.6663 6.34751 12.851 5.63542 3.55 -1.50526 -328 1 9.61828 1.90104 0.967862 -1.73511 6.80555 -16.7575 -329 2 8.75126 1.82608 0.511852 18.7109 -2.38487 5.6602 -330 2 10.2637 2.29933 0.349253 -13.3131 -4.11214 4.99441 -331 1 10.6435 13.4896 4.54607 -8.3754 1.2658 -1.96254 -332 2 11.4795 13.0515 4.69791 8.28938 -6.58305 0.731496 -333 2 10.5798 14.1432 5.24738 -1.32643 -0.553656 5.74704 -334 1 14.4543 1.71115 10.9546 -7.69161 -4.81009 -3.91494 -335 2 15.2136 1.28396 10.5547 4.80162 -2.13195 -1.67599 -336 2 14.6015 2.65135 10.8079 -1.60778 0.935868 6.54178 -337 1 14.5384 12.1186 11.6682 4.42158 0.0609916 50.1985 -338 2 15.3244 12.3738 11.2188 19.3883 10.0258 -22.7848 -339 2 13.838 12.0043 11.0592 -19.2299 -5.1918 -28.9193 -340 1 8.19636 5.07775 9.81895 6.92668 -2.08004 -5.22277 -341 2 7.38544 5.24812 10.3055 -3.33886 -3.05544 1.61921 -342 2 8.19204 4.12852 9.59915 -2.53054 10.0553 1.98192 -343 1 1.48663 16.8897 18.439 7.38955 -7.44055 -8.00122 -344 2 1.97341 17.2271 17.6702 -6.10601 -1.16576 3.12224 -345 2 1.43805 15.9298 18.2902 4.85843 10.0488 4.15854 -346 1 1.49392 17.3013 15.324 -13.7543 10.7593 4.06087 -347 2 1.44447 18.24 15.6259 -3.67575 -24.1287 -4.86768 -348 2 0.590882 16.9129 15.3122 14.6177 13.551 2.26757 -349 1 3.61646 5.75696 6.06482 3.05275 -16.2413 -2.75756 -350 2 3.17 6.32551 6.68313 -10.4039 6.81614 9.87761 -351 2 4.1613 6.3181 5.51248 5.12466 2.54076 -5.58469 -352 1 12.4579 9.47416 14.2028 -15.1686 39.1263 4.59508 -353 2 12.91 8.74193 13.8564 21.0065 -34.4741 -21.4004 -354 2 12.311 9.21984 15.1046 -5.21536 -3.05923 17.073 -355 1 4.05954 15.2722 6.9713 -12.2847 -13.6907 9.03639 -356 2 3.52733 16.0267 6.71946 -3.69787 8.1984 -1.38185 -357 2 4.94462 15.4979 6.70957 17.3953 3.39893 0.124931 -358 1 0.676716 8.64845 15.0435 0.0448789 -8.8726 2.29819 -359 2 0.388517 9.55355 15.1457 -0.102902 11.258 0.0552156 -360 2 1.38121 8.67263 14.3922 3.78483 -0.0353447 -4.44966 -361 1 12.9131 8.29224 10.2146 2.07907 -10.3878 2.68575 -362 2 13.6346 7.78925 9.80195 -2.79275 5.95566 3.91371 -363 2 12.8029 7.87463 11.0885 3.60602 9.09063 -7.955 -364 1 15.3505 7.77425 3.51602 -25.105 2.18251 -0.815364 -365 2 14.4666 7.51634 3.2857 -7.66712 2.41401 -31.383 -366 2 15.2516 7.5997 4.43625 29.5189 -3.75051 28.1293 -367 1 17.2908 6.71242 0.0288264 8.4359 -0.0595562 3.38218 -368 2 16.7481 6.02838 0.414195 -4.41494 -10.5616 1.77026 -369 2 16.6696 7.39667 18.4317 -9.71571 9.06541 -4.14994 -370 1 8.93558 6.94317 7.77066 11.3734 11.9101 1.30985 -371 2 9.8513 7.28708 7.82315 -13.5624 -4.9569 -0.419932 -372 2 8.83457 6.3282 8.49913 -0.351333 -9.82053 6.39411 -373 1 12.3886 0.605922 1.26733 4.3474 1.63423 -5.64369 -374 2 13.3496 0.62067 1.39833 -3.50709 5.26207 -1.10414 -375 2 12.2365 0.554465 0.317002 3.44844 -5.08055 2.164 -376 1 5.6093 15.1332 14.5298 5.50237 -6.63524 -3.85361 -377 2 4.67729 15.3131 14.6547 -7.5977 -3.56809 4.17708 -378 2 5.99198 15.9265 14.1501 5.33744 7.17763 0.920224 -379 1 3.83862 6.42399 1.72255 -0.530245 0.761181 6.81888 -380 2 3.42185 7.23588 1.41886 -3.5948 7.2146 -3.68667 -381 2 3.94102 6.55655 2.67261 0.00170673 0.796504 -2.59346 -382 1 3.90756 11.5263 12.3817 0.20855 -7.47029 -8.65749 -383 2 4.79535 11.8927 12.4625 -0.681042 -1.53834 0.918823 -384 2 3.33577 12.1179 12.8713 -4.93373 1.57702 0.731635 -385 1 5.31593 3.88159 15.8542 -0.71358 -42.6288 -12.177 -386 2 5.97198 3.22378 15.5406 -6.31298 7.40988 7.32158 -387 2 5.73536 4.71214 15.7787 14.3185 32.9857 -0.935745 -388 1 14.2562 10.2258 4.56557 -18.8652 24.4894 6.04548 -389 2 14.4389 9.92543 5.45169 -1.13053 -5.88778 11.8213 -390 2 14.6954 9.63367 3.98806 17.1426 -20.2086 -20.2139 -391 1 7.6892 17.381 9.10447 19.4711 -25.2283 0.682627 -392 2 6.86971 17.6207 9.51632 -14.1206 10.5396 4.24559 -393 2 7.90224 17.9622 8.37374 -3.5427 12.2774 -4.18627 -394 1 4.51373 14.5018 3.89084 0.522587 -13.0056 -37.966 -395 2 4.5996 15.4052 4.14706 0.258928 20.2029 10.6105 -396 2 4.49773 13.963 4.65868 1.58881 -14.8294 26.2191 -397 1 14.2556 7.39762 15.8429 -9.24001 -8.17606 -10.1746 -398 2 15.1854 7.31956 15.6389 10.3704 -1.38951 -4.38862 -399 2 14.2355 7.83779 16.6857 -0.295639 4.56275 12.5602 -400 1 3.05453 18.3862 1.94671 -28.337 -27.777 -22.0693 -401 2 2.58101 17.7651 1.32015 15.7039 17.8808 20.6311 -402 2 2.35293 0.259745 2.36363 3.01847 1.93426 2.5363 -403 1 7.98344 1.63895 4.58298 -1.95289 -5.65456 5.83277 -404 2 7.39472 2.00993 3.91227 5.60846 -0.877805 -3.34347 -405 2 8.83104 1.39808 4.18815 -5.23209 5.3786 -4.6966 -406 1 2.44155 14.16 17.683 19.8901 20.6744 -11.1998 -407 2 1.71949 13.6284 17.9614 -19.7639 -16.6874 11.6615 -408 2 3.22651 13.6749 17.9404 10.3416 -4.56611 4.09925 -409 1 0.874431 1.8172 13.9017 -2.66591 2.98819 0.0720706 -410 2 0.796895 1.67216 14.8604 0.805718 -0.9226 -9.7327 -411 2 18.6311 1.96655 13.5402 2.6832 0.103556 9.2189 -412 1 4.40474 18.7103 13.8903 -4.51489 2.73844 -3.11833 -413 2 5.26066 18.332 13.6843 10.2731 -0.629088 3.90858 -414 2 4.27285 18.5624 14.8326 -2.10334 -1.04281 2.89108 -415 1 7.22541 0.768378 18.3802 -7.41292 5.22253 -10.0414 -416 2 7.14919 0.357851 17.5011 6.06274 3.8916 10.097 -417 2 6.39657 1.25171 18.5223 1.70256 -10.1891 2.75464 -418 1 16.0038 18.3833 13.9769 4.60778 -2.90009 -16.1733 -419 2 15.0678 18.3553 13.7682 -2.12799 2.80836 4.60244 -420 2 16.1189 18.6995 14.8699 -6.8859 -1.5785 15.9997 -421 1 10.1619 4.59436 16.2508 34.7775 -10.6887 1.26028 -422 2 11.1678 4.58362 16.2281 -36.3206 4.79489 -1.20103 -423 2 9.8959 3.67942 16.0718 3.3051 4.94693 0.644026 -424 1 15.9268 17.7185 4.48585 -0.443376 -19.9814 -7.77196 -425 2 16.5546 -0.221465 4.56619 12.2284 16.6263 -2.03126 -426 2 15.0862 18.0786 4.73637 -15.899 7.019 6.15678 -427 1 6.9987 17.4508 13.864 -28.5259 -4.03497 -9.84039 -428 2 7.52153 17.7102 14.6061 10.1765 7.77338 18.9538 -429 2 7.63162 17.2858 13.1766 11.9873 -1.11294 -13.1093 -430 1 13.256 6.47431 6.57718 13.0919 -2.27803 2.33044 -431 2 14.2181 6.68617 6.52776 -23.2683 -1.75779 -6.09518 -432 2 12.9031 6.34478 5.6793 8.47748 2.51219 6.97161 -433 1 7.82324 2.30197 9.35649 6.58131 4.23212 14.3466 -434 2 7.32826 2.17284 10.185 -1.16662 2.6949 -8.43976 -435 2 7.24342 2.0875 8.62812 -8.03625 -5.88123 -5.84644 -436 1 15.1686 14.8419 13.6961 6.6084 -8.9126 -6.67367 -437 2 14.8499 15.0658 14.5674 -3.29174 5.55862 10.3748 -438 2 14.9102 15.5355 13.091 -7.311 3.85237 -1.87114 -439 1 9.39203 8.3247 3.79765 -11.0731 4.19637 -5.3616 -440 2 10.2213 8.76913 3.95172 10.5135 8.75123 3.89829 -441 2 9.56922 7.39926 3.9554 -1.92777 -9.54221 1.11885 -442 1 17.7628 13.6056 16.4368 0.454101 -14.0132 9.10192 -443 2 16.8123 13.4442 16.4542 -1.43638 -1.23592 -2.30674 -444 2 17.8812 14.4042 15.9249 -1.89469 7.90276 -3.85648 -445 1 4.90818 10.546 2.83916 0.136377 -2.73925 -10.4847 -446 2 5.60998 10.1288 3.34488 4.96678 -0.616571 0.115447 -447 2 4.51664 11.1769 3.44738 0.912314 1.46625 2.09919 -448 1 3.71104 8.38719 10.068 0.753133 0.0228827 -3.76935 -449 2 3.89927 9.29887 9.80067 -2.70003 -3.09285 3.15772 -450 2 3.67512 8.396 11.0298 -2.24059 1.87779 0.37074 -451 1 15.9565 6.94095 5.99865 -8.76526 9.77307 4.96327 -452 2 16.7516 7.41234 6.24421 7.68049 3.9133 2.85915 -453 2 16.2393 6.06165 5.75492 3.70751 -7.34759 -2.0072 -454 1 15.1339 7.14501 9.07066 -1.17949 -23.8082 27.0602 -455 2 15.8283 7.58235 9.55517 11.4438 5.0236 10.3868 -456 2 15.1116 7.57875 8.25013 -4.20744 20.1878 -38.3409 -457 1 6.25297 12.9267 12.7452 -4.72449 1.01458 -5.57239 -458 2 6.98991 12.3599 12.9819 6.62509 -1.61272 7.49964 -459 2 6.12032 13.5727 13.4468 2.47956 2.45399 3.39123 -460 1 12.1116 4.51066 13.1059 -15.4407 -10.6836 -10.9314 -461 2 12.4271 4.59486 14.0171 -10.4637 -2.65404 1.19035 -462 2 11.2547 4.00523 13.0473 26.1752 13.1928 8.83048 -463 1 11.3958 8.13336 7.91828 -4.43196 -2.05658 -14.2843 -464 2 11.9753 7.54394 7.4184 3.39578 1.92795 -0.521112 -465 2 11.8257 8.23937 8.76441 1.22007 0.905858 11.3028 -466 1 17.1296 10.8754 7.54699 -15.2323 -0.655909 3.97588 -467 2 17.811 10.2663 7.31344 17.8297 -18.4071 -0.448075 -468 2 16.9935 11.379 6.74844 -4.7697 12.6356 -6.62113 -469 1 5.29547 18.1363 10.9421 18.5805 -0.935137 -5.10578 -470 2 4.88577 17.8485 11.7431 -9.76906 -7.6723 14.1577 -471 2 4.62403 18.0611 10.2783 -13.9129 1.88822 -17.2145 -472 1 7.59234 17.5076 1.75687 4.86523 1.07577 -14.9702 -473 2 8.00304 16.7666 1.28453 -8.52174 0.253094 2.89961 -474 2 7.35564 18.1425 1.05706 3.89665 -2.44167 8.83688 -475 1 1.92302 12.8778 13.5789 2.91886 3.94981 -7.24471 -476 2 1.45818 12.4106 14.2651 -5.47786 -10.2367 6.99308 -477 2 2.33812 13.6191 14.0211 -0.459782 9.91978 4.14062 -478 1 9.50973 6.75636 14.7983 0.267759 -13.8501 3.13598 -479 2 9.76861 5.87974 15.1842 -3.78976 20.025 -16.8859 -480 2 9.67323 6.78366 13.8359 6.07296 -1.5477 12.5306 -481 1 15.3007 4.25662 10.7816 1.6835 6.93604 -0.852744 -482 2 16.2201 3.94716 10.8841 -13.758 11.9338 1.00514 -483 2 15.2044 5.07319 11.3041 5.68258 -12.2185 -1.66994 -484 1 11.2682 6.20917 0.148653 5.11845 2.03204 -0.614283 -485 2 11.4613 5.3156 18.5351 10.8417 -13.6045 -1.35957 -486 2 10.3344 6.26425 -0.02153 -13.2524 10.0913 1.35666 -487 1 -0.0515508 11.3921 15.0043 28.8186 -12.3739 35.7691 -488 2 18.1888 11.7008 14.2289 -27.1505 12.4881 -39.8426 -489 2 -0.144753 12.1488 15.5889 -3.39882 3.34168 7.51926 -490 1 7.01363 9.26741 7.30523 1.11866 9.50703 -8.15996 -491 2 6.64493 8.42979 7.58084 -4.10674 -7.85165 7.60391 -492 2 7.94964 9.11568 7.16987 5.72986 -2.82238 2.51511 -493 1 18.3266 15.3189 12.3109 1.98396 7.8422 -1.62162 -494 2 0.557814 15.686 12.1521 7.34904 -2.57966 -0.481227 -495 2 17.7488 15.821 11.7275 -2.3238 -0.409324 -3.46342 -496 1 16.5074 4.41847 5.29023 -12.2776 2.5176 -39.1335 -497 2 16.8214 4.00292 6.06235 10.453 -12.003 36.2431 -498 2 17.1989 4.29433 4.62557 3.70164 8.40848 3.22117 -499 1 17.7062 3.18115 10.7633 -10.0415 -0.498888 0.968384 -500 2 18.5829 3.451 11.0307 13.8857 -2.29821 0.377097 -501 2 17.7544 2.33603 10.3089 5.51555 -4.87272 -1.50428 -502 1 12.31 -0.0249004 10.0958 7.06597 -29.3992 -7.90418 -503 2 11.4091 0.228435 10.2265 -21.0592 11.9526 6.39906 -504 2 12.8361 0.735194 10.2786 15.1995 22.0824 4.66414 -505 1 10.3672 9.76964 12.4555 1.27225 -3.68083 -7.54967 -506 2 11.1341 9.82258 13.035 0.839453 -0.704743 2.83749 -507 2 10.2702 8.82174 12.2801 -0.554943 5.543 3.04928 -508 1 0.65465 2.77798 7.04528 -2.13863 -3.2199 7.00126 -509 2 0.891211 3.42266 7.72053 -0.0150652 2.55779 -0.825415 -510 2 0.990123 1.95336 7.40694 -1.54003 -2.33595 0.508806 -511 1 0.295674 15.3348 6.84982 -3.22172 27.5014 26.3495 -512 2 0.521244 15.1551 7.76985 -0.748412 3.60522 3.47657 -513 2 0.484365 14.5358 6.4159 11.6769 -37.1534 -21.5269 -514 1 17.0573 6.99129 15.1128 -10.0859 0.519269 -2.81001 -515 2 17.7626 7.64158 14.9811 2.36054 -7.88383 3.70046 -516 2 17.4128 6.20418 15.5441 6.5971 2.49163 -1.29874 -517 1 9.10445 12.4501 8.04005 25.0355 12.8023 20.768 -518 2 9.46092 11.7782 7.45434 -7.91968 -3.65307 -8.74082 -519 2 8.16829 12.5393 7.95206 -19.3694 -6.70788 -7.44718 -520 1 1.22811 1.76814 2.9182 -6.11732 -10.0295 -0.237983 -521 2 0.712195 2.08081 2.16479 2.12402 6.69579 0.750032 -522 2 1.58605 2.52034 3.3947 3.99278 5.86411 -0.360805 -523 1 4.10894 15.0956 9.93451 6.69744 -1.75099 -1.18621 -524 2 3.96901 15.3261 9.00671 4.91376 -1.44666 0.188494 -525 2 5.04659 14.871 10.0423 -6.23862 1.0691 -5.37016 -526 1 7.35274 2.18983 14.6875 -7.358 8.13743 -4.11606 -527 2 7.08638 1.65776 13.9297 0.32385 -1.91134 2.32143 -528 2 7.57979 3.04743 14.3014 5.83731 -4.25907 3.58957 -529 1 18.4915 14.5922 2.16266 -14.7631 20.4811 3.31696 -530 2 0.685462 15.0501 2.31645 0.801171 -7.89169 -2.84158 -531 2 17.8141 15.3012 2.20781 8.07106 -12.7893 -1.48401 -532 1 9.99475 2.73128 12.8993 -0.14498 6.34622 4.34107 -533 2 9.94968 2.10764 12.1674 -2.02697 0.25981 -1.25528 -534 2 9.23805 3.32791 12.8055 1.37719 -5.85529 0.104676 -535 1 2.96937 8.88969 13.0348 8.45161 15.4602 -1.6792 -536 2 3.19044 9.8379 12.866 -0.537566 -21.2484 3.2835 -537 2 3.7799 8.47356 13.3849 -14.589 3.50084 -4.12479 -538 1 3.21 8.56161 3.75492 -0.42537 -8.47878 -37.7314 -539 2 3.66747 9.30861 3.32521 -2.76458 -7.90594 7.43156 -540 2 3.22415 8.6869 4.6856 3.07128 8.62247 25.8231 -541 1 5.62342 7.20688 8.60781 8.60088 8.53717 -11.0276 -542 2 5.53536 6.26871 8.41561 -2.891 -1.4677 7.62716 -543 2 4.92494 7.48858 9.21156 2.86443 -6.54236 0.635755 -544 1 14.9008 1.47426 1.89198 -2.54888 27.9205 4.61998 -545 2 14.5535 2.29499 2.28075 -2.57285 -15.9361 9.92214 -546 2 15.4844 1.8547 1.23467 3.18874 -15.0862 -12.382 -547 1 8.48736 15.1158 0.783841 -1.15568 2.93173 4.22404 -548 2 9.1238 15.1934 1.5071 4.62293 -5.62872 -5.40551 -549 2 7.79285 14.5509 1.14844 -2.73481 2.50701 -2.31707 -550 1 15.539 1.37952 7.19688 19.4515 3.6409 9.83231 -551 2 14.9389 0.78101 6.7773 -13.8468 -10.3512 -10.8641 -552 2 15.0003 2.07296 7.57775 -6.55979 11.3773 -1.03994 -553 1 5.01034 12.9912 18.4705 -11.9235 -4.12885 0.570622 -554 2 5.4698 12.9987 0.669061 0.312037 0.832023 7.43214 -555 2 5.59011 13.4721 17.8825 4.88062 -0.262691 -5.03625 -556 1 15.3764 8.57785 18.0866 -6.62354 -11.676 10.0569 -557 2 15.6805 9.14973 17.3909 9.52323 10.3388 -11.2321 -558 2 15.2475 9.1488 0.206008 -1.03261 3.33477 1.75561 -559 1 12.066 3.08414 18.3349 -10.3405 10.2428 -1.58162 -560 2 12.3601 2.47993 0.38654 4.70786 -1.39849 -7.75748 -561 2 12.2507 2.72995 17.4495 4.61736 -8.1861 15.8047 -562 1 13.1968 12.6883 5.15757 -0.336282 2.96846 2.60586 -563 2 13.7743 11.9999 4.79412 -5.71366 -0.326721 6.52296 -564 2 13.1697 12.5812 6.12031 6.45904 1.498 -4.43193 -565 1 6.0986 7.21596 0.138974 -12.0498 11.3036 0.237585 -566 2 5.91833 8.16028 -0.0709607 9.65884 -21.2748 10.0237 -567 2 5.34258 6.95155 0.690129 5.85049 -3.44248 -7.26534 -568 1 17.7044 15.8891 14.9714 -7.43083 8.66678 -26.2685 -569 2 16.7907 16.1885 14.8618 6.06094 -1.91119 12.6189 -570 2 17.95 15.7638 14.036 5.46338 -3.82161 12.7361 -571 1 13.1509 0.939295 16.6327 -8.19033 8.72571 -1.54201 -572 2 14.0859 0.833936 16.7968 10.9207 -0.957234 5.29932 -573 2 12.8431 0.0418051 16.5014 -5.83506 -5.32332 -1.35137 -574 1 10.9522 14.5534 7.35938 -9.11436 -19.3925 22.6665 -575 2 10.1531 14.2304 7.85485 20.6615 9.00594 -18.4516 -576 2 11.6365 13.8859 7.56325 -5.91964 10.2955 -7.71128 -577 1 17.5919 8.49388 2.10024 -0.0322199 -9.95032 2.76416 -578 2 16.7206 8.43914 2.53345 10.0393 -1.69965 -6.58888 -579 2 17.6862 7.68098 1.5623 -5.40062 15.1321 4.16518 -580 1 12.403 7.83298 1.98454 10.1699 2.43182 8.97059 -581 2 11.823 8.58837 2.10452 -0.914469 2.41145 -5.63632 -582 2 12.0432 7.27751 1.28772 -5.41827 0.0907324 -1.12401 -583 1 12.0169 14.6214 10.4613 22.6496 -4.80377 11.9203 -584 2 12.2953 14.2566 9.62296 -0.627137 -3.48742 -6.53871 -585 2 11.0904 14.7922 10.4232 -26.4922 1.86569 -7.97999 -586 1 6.79945 6.92747 15.5042 -19.94 -13.6896 0.562857 -587 2 7.71181 6.85747 15.2524 19.187 5.43316 -2.40109 -588 2 6.75196 7.52139 16.2502 2.78602 4.81827 4.32857 -589 1 8.02489 4.54706 13.3799 -9.17747 17.7449 0.879178 -590 2 7.13549 4.71954 13.0119 14.9133 -0.721221 -4.30494 -591 2 8.45659 5.41872 13.4818 -10.582 -17.269 -1.29002 -592 1 13.3893 12.1928 14.3557 -6.07818 9.44403 7.21842 -593 2 12.9754 11.3343 14.2402 3.84433 -8.34325 -3.30791 -594 2 13.789 12.4346 13.5154 0.839467 -1.50598 -4.68274 -595 1 14.6037 9.51924 7.26293 11.3016 8.32374 8.02904 -596 2 15.4883 9.92697 7.3747 -13.533 -2.89904 3.77438 -597 2 14.03 9.85877 7.96896 6.22863 -2.20078 -8.30261 -598 1 12.724 16.8794 3.24165 4.36843 -29.0517 -11.6906 -599 2 12.9143 17.2056 4.10583 4.58985 8.72699 22.0136 -600 2 12.2764 17.5776 2.79705 -13.1015 20.2627 -13.4405 -601 1 1.027 7.08618 17.3856 17.8688 -9.35062 9.83545 -602 2 0.150845 7.20834 17.7372 -11.0357 -5.72224 6.2597 -603 2 1.04228 7.56687 16.5674 -0.430665 10.2682 -15.3686 -604 1 12.9047 4.96423 15.6783 -31.9319 9.90183 -0.420667 -605 2 13.6101 4.38571 15.8945 27.3027 -16.194 0.870052 -606 2 13.2534 5.85423 15.7473 6.89498 8.57473 1.28829 -607 1 2.36359 3.37095 5.13131 13.5367 -21.0772 -51.8355 -608 2 1.78827 3.18983 5.83511 -26.0337 -9.2034 36.1161 -609 2 2.76982 4.19309 5.31063 16.9607 33.0577 11.3338 -610 1 8.25673 11.0457 13.6214 -29.0742 18.4766 -42.051 -611 2 8.3505 10.9269 14.5387 12.3752 -9.07103 37.7912 -612 2 9.04494 10.7715 13.1556 11.3248 -9.59576 5.23465 -613 1 12.933 1.51857 13.2538 -7.42773 -10.5209 16.1392 -614 2 13.555 1.47666 12.536 9.8649 3.44918 -12.9241 -615 2 12.6435 2.43109 13.2999 -2.22529 4.34734 -4.74481 -616 1 6.5593 13.6321 2.14465 -6.91915 6.53865 -12.6846 -617 2 5.89828 13.9136 2.78341 -2.94652 3.12599 2.20918 -618 2 7.14809 13.061 2.63026 6.2374 -5.23981 3.14213 -619 1 15.8933 6.50668 12.6624 16.2584 4.45316 -6.00807 -620 2 16.3963 7.03445 12.007 -8.38894 -8.88658 12.5353 -621 2 16.4415 6.50555 13.4748 -12.028 3.27562 -10.9527 -622 1 16.7983 0.717045 9.56947 3.68169 11.9749 4.12436 -623 2 16.6133 18.4601 9.81273 2.15246 -18.3954 6.85595 -624 2 16.3759 0.833391 8.71872 -3.66349 3.7587 -11.8412 -625 1 6.14397 11.6556 8.30338 8.0817 56.4015 -2.32443 -626 2 5.40727 11.3941 8.82366 -25.1595 -10.6153 12.4164 -627 2 6.54205 10.8782 7.99323 17.2725 -41.4748 -11.5815 -628 1 2.81032 8.69956 0.356218 24.742 -6.25 8.21391 -629 2 2.27105 8.19016 18.4013 -14.5977 -1.17978 -6.66412 -630 2 2.29881 9.42159 0.72289 -11.078 1.63045 0.198871 -631 1 10.1064 10.4292 6.59515 -4.60438 -3.93729 0.830471 -632 2 10.5227 9.70923 7.07758 4.69601 -3.0134 2.20114 -633 2 10.434 10.3774 5.69507 4.10481 0.747976 -4.90006 -634 1 6.80466 15.7541 6.67201 6.06476 3.31695 -2.74514 -635 2 7.12474 16.199 7.46137 -2.48244 -3.95514 6.52968 -636 2 7.21004 16.2686 5.96286 -5.79252 -2.21211 -4.39766 -637 1 6.45958 12.986 5.74076 6.97467 7.4921 0.177054 -638 2 6.67553 13.8767 6.05203 0.11849 -2.56514 -0.0944634 -639 2 6.15828 12.5051 6.51647 -3.32664 -1.56183 1.61673 -640 1 16.774 12.5213 9.71798 -12.6143 2.89661 19.2402 -641 2 17.0082 11.8947 9.03708 5.67192 -3.35034 -8.73073 -642 2 17.3962 13.2453 9.69208 4.02202 2.48097 -6.52464 -643 1 6.17384 2.92225 2.79448 3.9775 16.0199 -22.3947 -644 2 6.54801 3.78326 2.49667 -7.94175 -14.5768 11.9424 -645 2 5.69703 2.59738 2.01124 2.48224 -4.95439 10.1002 -646 1 10.7977 3.13994 3.23713 3.9771 -4.26255 2.57443 -647 2 10.0782 3.73781 3.45741 -0.0760182 2.97522 -1.01161 -648 2 10.5069 2.61778 2.47973 -3.48459 4.35709 1.40724 -ITEM: TIMESTEP -70 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.80152 6.81783 17.9876 -13.1435 8.65537 6.0931 -2 2 7.93927 7.0215 18.3978 9.39494 -6.73756 -6.11522 -3 2 8.64173 6.15327 17.319 -1.79792 -4.8767 -3.2487 -4 1 0.159104 8.33212 6.75565 -1.75886 1.86255 -0.283403 -5 2 0.400553 7.98898 5.87058 -1.56937 3.6046 13.6337 -6 2 0.532733 7.75931 7.44677 0.588181 -1.3305 -10.9259 -7 1 8.56014 0.2064 6.86713 15.1827 -2.1442 1.30375 -8 2 9.48839 0.201881 6.58247 -8.47619 -0.963055 4.35965 -9 2 8.1657 0.891093 6.32874 -5.18544 5.82437 -2.7504 -10 1 6.48158 1.74839 11.7303 -5.73112 -6.99234 -4.49671 -11 2 5.77966 2.25139 12.1582 1.03612 1.63173 -0.79005 -12 2 6.04661 0.9684 11.3341 5.10627 10.6526 7.94811 -13 1 6.96595 5.58057 2.38836 1.68885 13.6464 8.05547 -14 2 6.50498 5.94206 3.17078 2.94101 -7.34901 -12.8293 -15 2 6.93975 6.29059 1.72807 -1.07971 -9.74986 0.444847 -16 1 16.2371 10.2379 16.1019 -30.9876 -7.62323 7.88585 -17 2 17.0175 10.5802 15.7054 20.7335 11.057 -7.58035 -18 2 15.6477 10.9912 16.2983 15.508 -10.4523 -2.02188 -19 1 10.7008 14.9379 2.28795 4.31472 -8.51672 3.50984 -20 2 10.6635 14.2367 2.95607 -1.08681 7.31624 0.965 -21 2 11.2207 15.6296 2.69467 3.48557 9.19098 3.66151 -22 1 17.1795 8.23023 10.7992 8.53416 -1.59534 -8.67541 -23 2 16.5643 8.83199 11.2261 -1.39923 4.26423 7.56567 -24 2 17.9421 8.77596 10.5426 -4.34729 -3.75626 -0.741474 -25 1 14.6688 15.978 16.4285 2.33326 -11.9168 -2.20454 -26 2 13.7825 16.2968 16.2522 -6.84331 1.16869 1.85073 -27 2 14.5784 15.3806 17.1932 6.40998 12.5602 -6.81985 -28 1 12.1084 13.347 0.550082 18.7888 -12.4001 5.31554 -29 2 11.808 13.4241 18.2861 -6.00468 7.05887 -5.4437 -30 2 11.724 14.0175 1.12482 -9.88619 2.03399 -6.75529 -31 1 9.30709 5.48775 3.90966 3.41698 -5.29876 17.2174 -32 2 8.77877 5.25688 4.68667 5.61339 2.83044 3.00189 -33 2 8.64592 5.55872 3.2299 -8.10772 2.16644 -16.0449 -34 1 1.64595 4.02425 11.592 -10.9656 22.1289 -13.9701 -35 2 1.60629 4.97108 11.8395 -0.824037 -11.4025 -3.90562 -36 2 2.20491 3.59841 12.2231 10.5337 -11.1868 16.6964 -37 1 2.06621 6.87149 8.22737 1.24172 3.77126 1.52806 -38 2 2.50304 7.30143 8.97949 -2.75541 -3.2118 -2.64013 -39 2 1.97282 5.93715 8.45613 -0.171499 4.52155 4.26063 -40 1 5.3374 4.4954 7.902 -9.99384 -2.48662 -4.40208 -41 2 5.3873 3.53885 7.92862 5.32096 -10.0353 0.506932 -42 2 4.78906 4.68538 7.13029 -0.632429 8.18831 0.496784 -43 1 3.33945 2.92164 17.4119 -9.04777 -8.0172 12.2496 -44 2 4.01569 3.37904 16.9228 10.8208 5.2633 -7.4392 -45 2 2.90871 3.59334 17.9575 0.609467 0.189965 -2.29637 -46 1 7.45919 5.40741 6.16401 6.01334 0.147035 -1.33637 -47 2 7.84933 5.9815 6.83711 3.51741 -4.84398 -5.3698 -48 2 7.00259 4.70355 6.63733 -2.11297 5.93299 1.70682 -49 1 9.81228 7.01862 12.0561 -1.06857 0.870105 -3.24483 -50 2 10.2542 6.3375 11.5392 -2.78202 1.90065 -0.0845581 -51 2 9.1292 7.39963 11.4807 2.35361 -4.5728 1.86322 -52 1 13.9947 3.68643 8.08173 -5.65395 18.5094 -17.1015 -53 2 13.7843 4.54079 7.64233 1.50666 -18.9 8.64197 -54 2 14.1479 3.8993 9.00085 4.5059 2.7709 6.99075 -55 1 4.5073 17.1442 3.93435 4.48768 -12.0008 8.39889 -56 2 5.39081 17.5321 3.92633 -2.26089 2.72179 -5.35255 -57 2 4.01543 17.3459 3.13072 5.98217 13.0117 -0.399635 -58 1 16.4079 16.585 10.4121 -12.3499 -1.91652 -12.9082 -59 2 15.5551 16.5364 10.8674 2.44262 -0.34105 -1.56006 -60 2 16.2254 16.2298 9.51738 1.66683 0.349555 15.5208 -61 1 1.97926 4.78245 0.194184 -7.72676 6.8376 3.32149 -62 2 2.28164 5.2243 0.992573 8.53964 -6.59001 3.21257 -63 2 1.76914 5.52567 18.27 -2.63275 2.53007 -9.16672 -64 1 11.4134 13.2491 16.3873 0.68902 5.27402 2.7566 -65 2 10.9787 12.3908 16.4988 0.445492 6.36744 -3.52589 -66 2 11.9797 13.161 15.6117 0.593117 -3.37138 0.847423 -67 1 10.1151 10.9818 16.8138 12.4788 0.931853 3.10073 -68 2 10.558 10.1255 16.7937 -4.12284 -0.882862 -0.541555 -69 2 9.18349 10.8105 16.7424 -13.6774 -3.43657 -1.9902 -70 1 11.7994 17.4667 13.4795 12.7765 -4.5476 -2.07039 -71 2 12.3346 16.8373 12.9682 -4.67996 5.77396 2.18605 -72 2 12.2169 18.3179 13.2967 -7.11407 5.85224 3.16387 -73 1 6.41771 9.40938 12.2612 -1.11473 -8.0868 -15.4525 -74 2 7.03744 9.07449 11.5759 -13.2083 9.2101 17.4474 -75 2 6.9295 9.8935 12.9066 11.874 3.71682 2.38348 -76 1 16.2958 12.8923 2.71536 -7.68956 9.05075 5.11912 -77 2 17.1057 13.405 2.60095 0.726983 -7.0699 -1.53932 -78 2 15.5966 13.5689 2.77432 5.93986 -8.84533 -0.161974 -79 1 0.748159 12.7086 5.88144 -10.9756 -4.32923 1.80334 -80 2 1.126 12.5118 5.01571 -4.75041 4.90571 -2.30818 -81 2 18.4243 12.6438 5.75836 11.281 1.67442 1.09101 -82 1 5.27578 16.4085 18.412 4.21131 -11.5608 4.53747 -83 2 5.56823 15.5611 18.0525 -2.79743 5.31701 -3.02359 -84 2 5.61546 16.4141 0.666595 -0.372752 7.00853 0.303479 -85 1 0.645783 7.7249 4.17395 -22.5174 -18.1833 12.2453 -86 2 0.0406635 8.03244 3.50183 -6.8254 3.26088 -7.40309 -87 2 1.47404 8.07846 3.91568 30.354 9.58108 -9.75695 -88 1 3.15689 8.99663 6.46784 -29.6014 22.5811 -11.1032 -89 2 3.73467 8.6187 7.10087 15.4493 -13.4368 20.8179 -90 2 2.24881 8.95158 6.82736 13.2955 -4.68481 -5.71698 -91 1 7.31562 10.4015 16.2316 3.59442 1.76188 5.73087 -92 2 6.55849 10.6763 15.7162 -1.33577 1.2968 -0.922241 -93 2 7.0153 10.388 17.1537 0.717273 -3.98644 -9.35278 -94 1 11.0545 0.930228 4.99952 5.57476 -3.06583 5.10436 -95 2 11.2493 1.80197 4.63341 -8.70362 -0.159614 -5.22362 -96 2 10.8601 0.352804 4.24475 -0.891787 5.80331 3.4075 -97 1 4.31226 2.88036 13.174 -5.147 13.5187 -3.07305 -98 2 4.38813 3.36721 14.0053 4.89736 -4.04185 -0.502489 -99 2 4.16611 1.96327 13.4122 -1.31506 -9.67947 3.52696 -100 1 8.44169 10.2311 1.79631 7.56357 -11.9838 -1.9735 -101 2 8.31668 10.8926 2.47474 -4.45102 7.488 6.50539 -102 2 8.68604 9.43265 2.286 -2.4935 0.872154 -3.30188 -103 1 10.3613 1.71229 15.5051 2.98347 -4.15867 -5.41234 -104 2 11.2858 1.47948 15.6006 4.17674 0.252173 3.54686 -105 2 10.224 1.77346 14.5485 -4.83776 4.02156 4.39256 -106 1 2.62824 12.9587 7.89058 0.896502 -11.3927 -2.22701 -107 2 3.24219 13.4607 7.34422 -0.123332 4.88452 0.659902 -108 2 1.95928 12.6032 7.2874 1.64097 5.4786 -0.796639 -109 1 3.80872 11.636 4.95037 -11.7682 3.18495 22.2339 -110 2 3.64598 10.9456 5.61445 0.836076 6.10931 -6.44063 -111 2 2.95096 11.8687 4.56439 8.15456 -6.07271 -3.548 -112 1 6.68955 14.4669 16.969 -3.81156 3.78561 -6.36768 -113 2 7.31157 15.1356 17.2607 6.01474 -1.04117 -0.64393 -114 2 6.3928 14.7335 16.0851 0.840242 -1.58899 4.15547 -115 1 14.2051 14.5083 3.2908 -7.03725 6.3674 -0.58292 -116 2 13.7783 15.3639 3.15563 1.95336 -1.87129 -0.261548 -117 2 13.7683 14.1355 4.06228 2.52608 -4.66484 0.961916 -118 1 8.56009 18.0702 16.0712 3.20396 -8.67406 4.91505 -119 2 9.14753 17.3445 16.2475 -6.34669 -24.466 3.58587 -120 2 9.1857 0.126611 16.1642 1.87484 33.3672 -8.78222 -121 1 4.70115 1.72624 4.89274 27.4793 -6.96303 -5.48355 -122 2 3.95894 2.26041 5.13304 -17.2548 11.1403 -0.356707 -123 2 5.27782 2.26423 4.3214 -9.62564 -3.87491 4.20048 -124 1 15.0192 12.5587 16.5123 21.7041 14.8698 31.7439 -125 2 14.5985 12.983 17.2917 0.468388 -8.58398 -21.4185 -126 2 14.4797 12.5149 15.7347 -25.1252 4.80555 -9.98379 -127 1 15.7034 18.4851 16.8595 11.2428 14.4774 5.40242 -128 2 16.3726 18.3616 17.5507 -1.30019 6.81093 -3.04699 -129 2 15.2229 17.666 16.8625 -3.30988 -17.6635 -4.60623 -130 1 1.33118 1.27529 16.6047 -9.4861 0.393225 2.74141 -131 2 2.17004 1.71925 16.7831 -4.45817 3.09534 0.768406 -132 2 0.687638 1.66877 17.2201 8.28198 -2.79213 -3.95818 -133 1 18.1871 4.40384 15.9188 -4.2246 -5.6904 -13.4727 -134 2 18.0103 3.84369 15.1415 2.73285 7.2293 11.0268 -135 2 0.486098 4.58175 15.924 0.765927 0.250404 0.0527718 -136 1 12.1931 17.0307 16.1573 -7.03075 -8.39993 15.6705 -137 2 11.4402 16.4961 16.4862 10.3932 12.5123 -4.95214 -138 2 12.1197 17.0939 15.2076 -10.1529 0.179256 -12.7611 -139 1 16.106 2.59107 18.2096 -1.1157 3.6739 1.58184 -140 2 15.8464 3.51014 18.3379 -6.23469 -2.00336 3.76026 -141 2 15.8431 2.36085 17.3192 0.233798 0.882779 -7.24243 -142 1 6.71273 13.8002 10.1277 -4.97427 -8.24119 9.58999 -143 2 6.56779 13.4217 11.0085 1.93353 6.26249 -2.22943 -144 2 6.54815 13.0587 9.53715 2.49444 0.869035 -6.59786 -145 1 10.1873 18.4315 2.70955 18.3562 4.9239 2.5593 -146 2 10.5434 0.318979 1.97838 -6.6136 -2.73616 6.22508 -147 2 9.38189 18.0459 2.39836 -17.7025 -5.54205 -6.95436 -148 1 3.04496 17.7072 6.14474 -26.0897 -13.5421 -17.7616 -149 2 2.15406 17.5302 5.73662 26.1077 6.8467 16.2169 -150 2 3.64192 17.5514 5.40101 1.03601 7.77362 4.67988 -151 1 12.6273 16.8318 7.93854 -11.3452 0.662957 5.12661 -152 2 11.8845 16.2201 7.89678 1.40738 -6.80959 -10.3945 -153 2 12.3926 17.3902 8.68441 7.00662 7.84172 2.34647 -154 1 14.8855 15.2416 8.18261 -13.4645 13.8861 12.0711 -155 2 14.0556 15.7424 8.32689 13.5062 -6.9847 -4.51651 -156 2 15.2561 15.6092 7.37576 4.4997 -5.95581 -2.20609 -157 1 17.7963 18.2323 0.313468 22.8316 -1.73762 -16.8861 -158 2 18.5551 17.7341 -0.0636659 -20.2187 -0.580139 11.9305 -159 2 18.2144 0.43747 0.484185 -10.4644 5.54896 5.21224 -160 1 0.772309 10.5133 1.37975 -10.1333 -30.1062 6.79594 -161 2 0.0813059 9.81759 1.5081 15.2254 18.695 2.54909 -162 2 0.385285 11.1613 0.797203 -0.976125 9.32481 -5.57513 -163 1 1.78018 12.2676 3.33949 2.15539 9.4235 -7.57379 -164 2 1.54035 11.6193 2.6706 -4.1225 -6.27654 2.3776 -165 2 2.05243 13.0385 2.81809 -2.70385 -1.96831 6.56166 -166 1 0.659925 17.2426 4.96586 -18.1386 9.04401 18.0738 -167 2 0.178596 18.0473 5.21064 6.21229 2.02654 -16.1731 -168 2 0.324647 16.6226 5.62628 12.0605 -8.44774 -8.6881 -169 1 1.10032 0.835558 9.36207 -6.74911 6.08386 15.0138 -170 2 1.34007 0.666464 10.2949 -2.02307 -2.81345 -10.1719 -171 2 0.1714 0.592543 9.31025 -1.22709 -3.40717 -2.54195 -172 1 16.7505 2.35163 13.3289 8.60057 15.8485 -12.5846 -173 2 16.88 2.58008 12.3859 -1.48994 0.98841 16.7513 -174 2 16.5792 1.4154 13.3346 -5.94985 -15.1034 2.43107 -175 1 2.68711 15.9094 12.0537 -2.04437 -0.129745 31.1177 -176 2 3.02052 15.4906 12.8711 -6.40464 9.26827 -14.3072 -177 2 3.17282 15.5129 11.3342 0.535683 -2.02659 -8.3952 -178 1 16.4208 15.6182 6.1352 -21.1289 -3.6799 -9.5135 -179 2 17.2955 15.5836 6.51556 8.3115 3.57969 -3.1518 -180 2 16.3537 16.3493 5.49765 5.76519 -7.13598 7.22522 -181 1 5.79664 5.13529 11.8088 -4.38676 10.3557 2.90642 -182 2 5.60006 6.00552 12.2032 -0.739769 -8.67447 -3.0914 -183 2 5.02307 4.59055 11.9941 4.66701 -2.35447 -0.0408817 -184 1 15.1607 4.87263 0.806669 16.5091 -1.57376 7.82361 -185 2 14.8955 4.71033 1.72542 2.63671 -2.24198 -6.9535 -186 2 14.4069 5.23734 0.370441 -15.2288 7.71764 -6.62645 -187 1 16.3977 16.3968 1.96949 3.68196 12.8197 -24.7966 -188 2 15.8359 16.7471 2.65913 3.23547 3.93446 11.4731 -189 2 16.7724 17.1777 1.4991 -6.44753 -16.1278 10.1249 -190 1 0.213933 4.82135 3.88253 -26.808 7.93653 -12.3623 -191 2 0.234051 5.77519 3.99531 2.75938 5.29795 -1.25016 -192 2 0.961943 4.50047 4.34745 23.7428 -13.1307 13.4767 -193 1 2.96019 15.0595 15.1256 -5.74802 5.98414 7.79678 -194 2 2.74143 14.6748 15.982 5.94976 -7.2483 0.528018 -195 2 2.64636 15.9627 15.2549 -2.4967 2.40481 -11.2251 -196 1 1.11613 14.6445 9.47707 24.3082 -3.71628 -27.1602 -197 2 1.83443 14.0608 9.11052 -24.4018 17.7336 11.9542 -198 2 0.662892 14.1245 10.1216 -3.75634 -10.5151 15.6601 -199 1 13.5123 16.5361 11.5209 14.3415 8.92342 18.194 -200 2 13.0624 17.3115 11.1648 -0.833334 -0.722864 -7.66511 -201 2 12.9752 15.7809 11.2867 -3.03575 -6.70349 -11.2125 -202 1 4.68996 1.46706 0.718872 11.9134 2.33738 12.4928 -203 2 4.09477 2.04355 0.241198 -5.36661 3.4607 -5.79099 -204 2 4.1604 0.969338 1.36347 2.85434 0.638429 -14.0321 -205 1 1.49954 18.563 11.8891 -5.50653 18.8512 6.56283 -206 2 1.44134 0.571379 12.6129 -0.0136494 -9.64138 -5.67935 -207 2 2.21117 17.97 12.1221 3.30859 -8.66659 1.78907 -208 1 11.4402 10.1273 4.0296 -14.1313 -2.26429 -1.73879 -209 2 11.5467 10.5306 3.16018 -4.20959 -0.177974 3.37558 -210 2 12.3237 10.0244 4.36159 16.2917 -0.468181 5.60308 -211 1 8.19952 12.1987 3.67367 7.5254 -0.929385 2.30686 -212 2 9.06593 12.5735 3.89529 -5.56433 -0.233543 6.4332 -213 2 7.60827 12.3201 4.43288 5.90715 0.804339 0.890554 -214 1 14.5695 4.00736 3.30806 -0.853883 -3.91237 -3.28064 -215 2 15.2428 4.12216 3.97778 4.83301 -0.192226 6.11595 -216 2 13.7947 4.43075 3.66998 -10.7695 5.18811 0.448659 -217 1 5.68852 1.65707 7.54168 28.123 23.6896 24.0894 -218 2 4.98915 1.23464 8.0079 -23.0977 -17.1785 12.6492 -219 2 5.54722 1.47278 6.63267 -9.12733 -3.0122 -32.3212 -220 1 17.8871 1.01837 4.84182 2.82015 7.71075 0.411156 -221 2 18.4334 1.54735 4.24341 -1.55475 -9.21419 -1.50179 -222 2 17.685 1.60385 5.57556 -2.0638 -1.04483 2.6292 -223 1 6.8166 9.34907 4.51783 5.09473 -9.82493 1.7662 -224 2 6.68916 9.48214 5.46541 0.845655 -0.0829088 -1.52267 -225 2 7.72677 9.02302 4.42297 -5.47106 2.64724 -1.23342 -226 1 2.52902 14.8001 2.0243 -5.93162 -1.84873 -28.2955 -227 2 3.33024 14.7833 2.53171 11.9325 -2.28831 13.4023 -228 2 2.81062 14.7362 1.08886 -6.14041 -0.158095 16.8135 -229 1 17.2862 12.9192 13.1313 -13.4327 18.0081 -1.69868 -230 2 16.3974 13.2513 13.3936 19.5241 -4.39437 -6.93828 -231 2 17.8009 13.724 12.9107 -8.95295 -13.2998 3.51907 -232 1 14.8818 10.557 1.42323 -17.5015 7.25829 9.68839 -233 2 15.2835 11.3752 1.77244 -3.15433 -10.3089 -2.91904 -234 2 13.933 10.5609 1.67153 21.0133 3.93252 -5.34474 -235 1 5.70173 6.62264 4.58284 3.01718 2.50499 1.71703 -236 2 5.75902 7.56019 4.39794 2.55817 9.91828 -0.0203224 -237 2 6.42399 6.43452 5.20085 -6.85011 -4.70646 -2.52597 -238 1 8.0341 8.36204 10.3892 10.4405 -6.77488 -14.8808 -239 2 8.6296 8.90948 9.85447 -2.74542 2.30932 7.48232 -240 2 7.64772 7.74454 9.75603 -3.95063 2.60786 3.00172 -241 1 13.4272 18.4528 5.67238 9.25795 -5.11499 9.49722 -242 2 12.7163 0.440246 5.56173 -10.019 1.98309 -6.96611 -243 2 13.1619 17.9514 6.45613 2.7128 -4.57063 -2.8 -244 1 -0.0270522 2.62208 0.316378 14.2494 -14.2567 4.73545 -245 2 17.7181 2.78355 18.7164 -19.3625 -8.86024 -5.69671 -246 2 0.361548 3.46719 0.160861 21.2807 17.6319 0.792983 -247 1 12.9304 10.9756 9.73287 -28.9199 -18.5822 3.85047 -248 2 11.9453 10.9259 9.78333 22.7984 8.3459 -7.73181 -249 2 13.1639 10.0723 9.99967 2.00349 4.19966 -2.07729 -250 1 0.632704 12.1509 11.1096 7.92792 10.2243 1.08862 -251 2 18.3238 12.1837 11.2671 1.30826 1.36738 8.17016 -252 2 1.12128 12.4175 11.9061 -11.5401 0.628467 -1.63311 -253 1 5.16172 7.34292 13.3779 5.89076 -0.786387 1.26512 -254 2 5.63913 8.13751 13.0818 -0.253704 -8.62988 -1.18816 -255 2 5.64992 7.00871 14.1461 -2.49218 7.71701 -3.25354 -256 1 1.18315 6.80996 11.9457 -21.1971 9.90527 -11.1777 -257 2 0.396163 7.2181 11.5121 19.4256 -12.5543 10.5539 -258 2 1.74685 7.55572 12.1675 3.51989 2.12142 1.71712 -259 1 15.5171 9.71047 12.3281 2.29457 -6.5479 -4.23973 -260 2 15.3017 10.6102 12.0519 -2.15799 -4.39765 10.01 -261 2 15.6816 9.70968 13.2745 -0.591496 3.33032 -0.321137 -262 1 16.5873 12.6729 5.56721 2.76163 -0.166181 -5.31991 -263 2 16.3773 13.5773 5.84608 0.225425 -0.965456 -7.72797 -264 2 16.4542 12.6253 4.60029 -0.729256 4.09093 10.083 -265 1 6.36605 9.79142 0.024922 -16.0501 18.8211 -0.426432 -266 2 5.53971 10.2677 0.213525 8.17613 -4.10964 1.60097 -267 2 6.98218 10.0336 0.714657 7.30358 2.91784 7.9977 -268 1 12.2857 6.09281 4.02237 -18.7873 -18.2554 10.8389 -269 2 12.2499 6.90248 3.51498 -0.180994 1.77121 -11.4426 -270 2 11.3769 5.71462 3.99073 18.6718 6.8659 -0.0124277 -271 1 0.371339 12.8581 0.116813 -11.2914 -0.881026 -5.3546 -272 2 18.6979 13.4634 0.798717 1.88955 0.580482 0.906428 -273 2 18.4407 13.0157 17.9982 0.051521 1.66817 1.81741 -274 1 3.57562 18.6672 8.63597 16.8652 -4.29809 -8.00937 -275 2 3.39672 18.3023 7.75382 0.438355 1.17547 6.33464 -276 2 2.72388 0.290377 8.97499 -6.05452 1.31479 -1.62581 -277 1 7.38199 17.3678 4.46374 -1.38292 15.3105 6.33947 -278 2 7.69148 18.255 4.75287 -6.89683 -17.7129 -9.79531 -279 2 7.51455 17.3077 3.50947 0.595015 4.11355 1.7546 -280 1 9.26329 17.1448 12.185 -8.64248 6.96454 5.63337 -281 2 9.31183 16.2501 11.845 1.80177 -5.78684 -3.53436 -282 2 9.93599 17.2354 12.8685 5.43729 -1.39148 -3.55242 -283 1 13.2821 13.1028 8.02698 11.8692 -15.3168 6.16039 -284 2 13.4688 12.3189 8.5813 -8.97739 12.1367 -7.14337 -285 2 14.105 13.618 8.04076 -8.38267 2.98351 0.0644509 -286 1 14.8025 2.98142 15.4294 17.4288 1.80056 -2.61073 -287 2 14.201 2.26032 15.2834 -13.2348 -7.60023 -2.35086 -288 2 15.3302 3.01554 14.6169 0.118996 0.402428 5.45631 -289 1 9.92493 15.6251 16.9821 6.00495 -5.53666 -0.13681 -290 2 10.4191 14.8506 16.6821 -3.27256 -3.64184 -5.012 -291 2 9.59076 15.3546 17.8439 -3.58917 5.2502 2.724 -292 1 11.2797 8.49868 16.6198 -1.73472 -6.52809 -3.79184 -293 2 10.75 7.88393 16.0952 -2.42874 5.03231 0.808132 -294 2 11.4092 8.05007 17.4587 2.82097 -1.86681 0.519814 -295 1 4.04678 18.2455 16.7988 -8.77416 25.1666 -6.65304 -296 2 4.65779 17.694 17.284 2.06605 -2.99109 10.2548 -297 2 3.96053 0.454509 17.276 5.60906 -19.8799 -5.16878 -298 1 2.27095 4.25175 8.91936 5.9784 -6.58712 9.82608 -299 2 3.2186 4.2524 8.72216 -4.79336 -1.38402 1.94738 -300 2 2.18112 3.96584 9.85003 1.09756 8.39619 -11.3917 -301 1 9.88624 10.3936 9.78011 6.22166 -2.86793 -13.7384 -302 2 9.62293 11.2772 9.51568 -5.75811 3.67729 -6.27375 -303 2 10.0642 10.4241 10.7104 0.548842 -0.969577 22.0405 -304 1 9.71663 0.937962 10.8586 -0.709221 -7.70358 -11.4846 -305 2 9.30987 0.134657 11.1937 5.18354 -4.14977 6.17978 -306 2 9.11908 1.1943 10.1452 4.37988 8.3302 1.85952 -307 1 9.18198 15.0956 10.1953 -4.26962 6.22766 7.58802 -308 2 8.89777 15.9846 9.95951 0.743088 2.4445 -7.53567 -309 2 8.34997 14.6032 10.2066 5.52748 -3.88041 -1.79992 -310 1 0.872205 9.70338 10.2435 26.5305 -15.7209 -40.6294 -311 2 0.885793 10.5746 10.6186 -2.04601 10.7115 5.01116 -312 2 1.5471 9.74995 9.50099 -28.1395 -6.59839 33.8889 -313 1 17.1072 4.85649 8.10795 10.9462 -15.5033 5.93553 -314 2 16.3968 5.45295 8.31142 -11.4282 10.1371 2.96807 -315 2 17.1775 4.27052 8.87929 1.82351 6.10377 -11.9311 -316 1 14.794 14.6968 0.0807509 -15.0506 -16.2211 -7.1198 -317 2 15.1293 15.3316 0.707575 7.57499 5.98458 11.2724 -318 2 13.942 14.3729 0.412504 5.92115 1.12787 4.02247 -319 1 3.8058 11.0463 9.54758 -4.72716 5.89465 -11.0149 -320 2 3.75265 11.4758 10.4012 1.08641 -1.46789 11.7249 -321 2 3.34125 11.6425 8.94232 1.4747 0.62014 0.836248 -322 1 11.3036 10.7395 1.51518 17.421 7.70001 -9.9965 -323 2 11.5572 11.5513 1.04939 0.916953 -2.49636 4.28379 -324 2 10.3663 10.6689 1.38091 -17.6315 -2.91035 -1.9437 -325 1 13.1498 7.19173 12.6392 -12.6781 -12.1868 5.62798 -326 2 14.0645 6.9093 12.7169 6.63809 2.55694 -2.55252 -327 2 12.6264 6.38473 12.8035 6.43409 8.48166 -2.8301 -328 1 9.6244 1.91603 0.948782 1.73007 4.87205 -17.2591 -329 2 8.78103 1.84907 0.47922 2.387 -4.26061 4.8929 -330 2 10.2561 2.20979 0.275304 -2.56753 1.91417 5.98087 -331 1 10.6541 13.4625 4.53479 -4.64228 5.78216 2.02785 -332 2 11.5543 13.1406 4.67483 -3.60366 -2.8444 3.58336 -333 2 10.4931 14.1115 5.23949 3.28752 -7.90473 -1.94244 -334 1 14.4847 1.66582 10.9548 -5.6847 9.24739 -2.41061 -335 2 15.2495 1.25185 10.5509 3.51804 0.734089 -1.48015 -336 2 14.6665 2.62215 10.9157 -2.44239 -9.64589 2.94827 -337 1 14.5153 12.0551 11.6598 -8.57838 4.331 1.02894 -338 2 15.2406 12.4341 11.1775 15.6624 8.75252 -5.54666 -339 2 13.8905 11.8145 10.9694 -5.00706 -1.53612 2.9308 -340 1 8.18805 5.09916 9.82303 -13.8101 6.02591 4.86356 -341 2 7.31243 5.14562 10.2589 14.5937 -0.354252 -5.27398 -342 2 8.2462 4.20505 9.47267 -0.0530366 -3.80538 1.315 -343 1 1.47125 16.9173 18.4665 17.3664 16.657 -21.1079 -344 2 1.9236 17.2269 17.6455 -9.65792 -6.20403 18.6505 -345 2 1.59593 15.9726 18.4726 0.464255 -9.97504 -1.82966 -346 1 1.48039 17.3287 15.3228 1.51401 14.0556 6.72393 -347 2 1.34693 18.2292 15.6575 8.56134 -5.76509 -0.66881 -348 2 0.596093 16.984 15.2507 -11.2139 -7.77617 -1.25224 -349 1 3.58273 5.77174 6.05172 -7.98503 -18.1926 7.56457 -350 2 3.04578 6.35459 6.60151 3.24577 3.33226 -0.333817 -351 2 4.18271 6.30655 5.53303 2.15541 4.89174 -3.71227 -352 1 12.4965 9.48476 14.2165 -0.670713 16.0192 -6.73881 -353 2 12.9556 8.76438 13.7775 2.07937 -6.9932 3.10842 -354 2 12.3436 9.22115 15.1264 1.05397 -7.72063 3.19376 -355 1 4.0654 15.2599 7.01126 14.536 -9.99762 3.77636 -356 2 3.57418 16.0458 6.77165 -4.77502 7.81332 -2.1228 -357 2 5.00035 15.4681 6.83264 -6.89866 -1.23873 3.67355 -358 1 0.723833 8.69198 15.0851 1.39297 0.947643 -5.33928 -359 2 0.438801 9.60781 15.1421 -2.06214 4.43911 1.45744 -360 2 1.38458 8.70272 14.3802 0.858615 -3.42768 2.38717 -361 1 12.8756 8.29184 10.1606 18.5084 -5.85873 3.08502 -362 2 13.7209 7.89345 9.85142 -16.8549 4.13316 8.30657 -363 2 12.7515 7.97965 11.0724 6.23426 1.04322 -7.42686 -364 1 15.3229 7.8277 3.50947 17.5558 22.7432 -34.5468 -365 2 14.4697 7.71438 3.07339 -7.31906 -8.87793 15.8657 -366 2 15.4806 7.65388 4.43399 -18.8005 -15.0751 11.2523 -367 1 17.2596 6.73529 0.0260639 -2.34928 8.60384 0.474092 -368 2 16.7705 6.01921 0.434638 -6.55856 -4.92879 -0.567585 -369 2 16.5991 7.41683 18.4475 3.41319 -8.53114 -0.808778 -370 1 8.95463 6.95692 7.78734 -12.7059 -4.64784 9.91199 -371 2 9.87027 7.23168 7.81087 8.51327 4.71948 -0.0600656 -372 2 8.83651 6.35153 8.53608 0.68522 0.961995 -1.89804 -373 1 12.4059 0.607414 1.26231 3.62116 2.02707 -9.0712 -374 2 13.2571 1.01103 1.48145 3.02509 -6.80244 -1.55076 -375 2 12.4394 0.42011 0.312768 1.30302 -0.072107 7.45087 -376 1 5.61221 15.1181 14.5069 21.81 1.56396 -5.03583 -377 2 4.69671 15.2613 14.7447 -7.9418 2.21424 1.99916 -378 2 6.02853 15.9808 14.3125 -8.14435 -8.16553 0.0834836 -379 1 3.81616 6.42663 1.71897 -4.74342 3.6354 -4.79161 -380 2 3.34042 7.16969 1.31421 3.65203 2.80462 3.7212 -381 2 3.89499 6.64183 2.65143 -2.11765 2.44111 2.19083 -382 1 3.90516 11.4598 12.3793 9.45586 -8.94044 -12.3546 -383 2 4.79548 11.8227 12.4942 -7.15738 -0.735807 -0.876075 -384 2 3.31554 12.0782 12.7961 -9.4854 7.67777 7.65311 -385 1 5.30665 3.87758 15.8091 -6.5654 14.2288 -0.0449474 -386 2 5.99806 3.22942 15.6938 11.0923 -7.17561 -6.6845 -387 2 5.74209 4.7421 15.8325 -0.91092 -4.98763 -0.535492 -388 1 14.1952 10.2038 4.61463 -6.5923 1.74463 -22.8561 -389 2 14.2343 9.86507 5.49824 4.23866 -7.49318 19.2708 -390 2 14.5963 9.53108 4.04607 2.17028 4.66107 2.75401 -391 1 7.63145 17.3499 9.0679 -5.43123 5.71002 -0.0698024 -392 2 6.89643 17.6949 9.58041 -2.21022 -5.88459 7.45639 -393 2 7.83827 18.0718 8.46746 8.40651 -1.69566 -7.5742 -394 1 4.52514 14.4769 3.85867 5.05038 7.53463 5.39007 -395 2 4.64261 15.388 4.18066 -3.91408 -9.29834 -6.31781 -396 2 4.46355 13.9264 4.6465 1.7827 -2.93555 -2.6265 -397 1 14.2493 7.38723 15.8586 4.87219 -5.15553 -0.709446 -398 2 15.1473 7.29965 15.5014 -5.21416 1.68161 3.76194 -399 2 14.3665 7.7773 16.7353 0.544226 -0.39761 -4.2243 -400 1 3.0581 18.4144 1.95119 -22.1859 -8.41359 7.65322 -401 2 2.57832 17.7386 1.43356 3.30075 12.2585 2.4632 -402 2 2.38613 0.281938 2.45339 8.18993 -10.3808 -10.0068 -403 1 7.97435 1.63455 4.58282 23.9975 -9.20271 -17.826 -404 2 7.40194 1.94347 3.87976 -9.32013 4.13397 -1.27928 -405 2 8.80392 1.4125 4.10448 -12.4762 5.5818 15.8983 -406 1 2.4378 14.1623 17.6894 -3.94912 5.20331 -2.53114 -407 2 1.6661 13.615 17.8755 3.58117 1.8004 4.78536 -408 2 3.18519 13.6404 17.9779 13.28 -5.73443 1.82606 -409 1 0.901685 1.86492 13.8925 12.6905 0.691236 2.76957 -410 2 0.97461 1.67681 14.8348 2.02403 -0.73996 0.457614 -411 2 -0.0244921 1.99897 13.7259 -14.1961 2.08272 -4.4518 -412 1 4.37872 0.0904002 13.8777 13.1739 1.11326 -7.50903 -413 2 5.30332 18.4699 13.7308 -6.52685 1.52196 1.48666 -414 2 4.22979 18.5754 14.8098 -5.10379 -2.3914 9.04502 -415 1 7.27651 0.845893 18.3957 -16.6762 17.2151 26.568 -416 2 7.1678 0.492927 17.521 -0.448362 -6.22938 -12.6047 -417 2 6.39207 1.1517 18.718 17.8505 -10.612 -11.3067 -418 1 15.9607 18.375 13.9642 -35.6371 5.35013 -16.5011 -419 2 15.0008 18.4642 13.7578 26.2499 -2.51915 -0.30366 -420 2 16.0214 0.00880953 14.871 6.50934 -2.46523 19.0717 -421 1 10.2176 4.60873 16.2514 5.45645 -16.296 -9.2455 -422 2 11.1834 4.4434 16.3559 -20.4013 6.80033 -5.0518 -423 2 9.84346 3.80184 15.8357 11.7075 10.859 12.3241 -424 1 15.9288 17.6854 4.49702 -25.8895 1.84686 -2.2825 -425 2 16.5611 18.3979 4.49336 8.57016 10.0602 -1.14853 -426 2 15.0697 18.092 4.72548 12.7214 -6.58434 0.45321 -427 1 6.97646 17.4765 13.8835 1.51347 6.32825 6.74987 -428 2 7.46829 17.7625 14.676 -2.92413 -3.08896 -9.25103 -429 2 7.63479 17.4162 13.1781 -0.793447 -1.23312 2.0982 -430 1 13.2369 6.46193 6.55272 7.97686 -7.07829 -14.9633 -431 2 14.2045 6.47863 6.50403 -7.11621 7.88379 2.07663 -432 2 12.9571 6.40302 5.61769 -2.27464 -2.27743 14.9713 -433 1 7.84752 2.28013 9.41028 -8.73892 -0.731414 -17.5278 -434 2 7.29261 2.26329 10.1936 -2.39479 -1.12016 7.77392 -435 2 7.27021 1.99883 8.67538 7.42107 2.89864 6.55304 -436 1 15.163 14.8378 13.7075 -5.08255 6.9114 -1.94911 -437 2 14.828 14.9803 14.5966 0.517852 0.790599 5.03408 -438 2 14.8205 15.5736 13.1818 1.46712 -6.90646 -0.613497 -439 1 9.40195 8.33905 3.81803 -16.6236 -1.1153 -3.723 -440 2 10.1861 8.88666 3.81624 11.7714 1.21262 5.85608 -441 2 9.65895 7.42947 4.01423 -0.646232 2.08147 -2.76231 -442 1 17.7496 13.6056 16.4496 1.61536 7.2683 -6.30775 -443 2 16.7925 13.5164 16.4445 -3.33508 -5.74033 1.31806 -444 2 17.9176 14.3949 15.9026 -1.24178 -7.25826 8.29135 -445 1 4.89231 10.51 2.8606 23.2586 -26.6571 -20.5821 -446 2 5.63741 10.0083 3.24852 -7.78968 12.4235 -4.83768 -447 2 4.54582 11.03 3.56787 -4.03679 11.8248 12.8852 -448 1 3.69823 8.4002 10.0127 -3.60192 -11.2793 13.5005 -449 2 3.83759 9.3113 9.76164 0.279778 8.83932 -1.11316 -450 2 3.64192 8.42085 10.9836 -1.53751 -1.28356 -9.75822 -451 1 15.9467 6.92332 5.94112 11.8737 -8.24502 3.37919 -452 2 16.7476 7.39494 6.19571 -0.497479 1.69122 3.51528 -453 2 16.2467 6.02535 5.70675 -5.68891 13.7396 -0.851978 -454 1 15.1658 7.18492 9.0507 -10.4703 -15.8706 0.47552 -455 2 15.9236 7.59272 9.46168 11.862 8.93317 3.67812 -456 2 14.9906 7.60382 8.20629 4.02444 8.70872 -4.23998 -457 1 6.21618 12.8841 12.7284 -3.21766 12.2709 11.5322 -458 2 6.77909 12.207 13.0973 14.7659 -5.65099 1.01901 -459 2 6.15827 13.5741 13.4151 -3.2657 -3.93324 -9.28774 -460 1 12.1165 4.51288 13.1048 -1.62418 -0.0716723 20.7898 -461 2 12.3817 4.58382 14.0419 2.18295 3.85449 -11.1604 -462 2 11.2475 4.10019 13.1569 -0.321339 -3.45694 -9.73345 -463 1 11.4166 8.11249 7.92599 8.37678 -3.86112 -10.8327 -464 2 12.0468 7.60844 7.37796 -5.38848 4.21425 7.2331 -465 2 11.8428 8.18692 8.79136 -5.59584 -0.0130509 -4.24997 -466 1 17.091 10.8655 7.57222 -5.5019 -10.6926 10.9756 -467 2 17.8562 10.3128 7.37833 -2.02493 -0.998523 -7.2616 -468 2 16.8515 11.3839 6.80089 6.08197 4.8342 -8.48749 -469 1 5.2937 18.1227 10.8823 3.58086 -4.72457 -4.80722 -470 2 4.89277 17.7527 11.67 -2.28546 -3.10604 1.32943 -471 2 4.67512 17.9479 10.167 -5.31481 4.288 -3.34371 -472 1 7.59808 17.4966 1.71058 0.398559 1.64094 13.9409 -473 2 7.8828 16.705 1.25288 5.11743 -4.18927 -7.63945 -474 2 7.62118 18.2252 1.08608 -3.03358 1.0728 -8.8916 -475 1 1.91712 12.8862 13.5909 8.98798 9.32187 -3.03347 -476 2 1.48166 12.3531 14.2581 -2.09819 -2.06604 3.51643 -477 2 2.30811 13.6552 14.041 -7.16378 -5.11315 -1.13098 -478 1 9.42828 6.75322 14.7826 20.1915 -11.5504 -11.1057 -479 2 9.8277 5.94835 15.1588 -6.88663 6.02054 3.69259 -480 2 9.80073 6.79406 13.8821 -8.1098 8.28496 9.35183 -481 1 15.2968 4.25709 10.7854 2.83104 8.23395 -4.89519 -482 2 16.2313 4.08269 10.6128 -5.94582 -2.20316 7.08238 -483 2 15.3124 5.02999 11.3646 -3.5924 -3.42311 1.83328 -484 1 11.2927 6.22318 0.123361 12.5475 12.622 0.859144 -485 2 11.5233 5.29113 18.7512 -7.74436 -5.44097 -5.24926 -486 2 10.3808 6.34995 18.4806 -0.327163 -9.85792 5.03233 -487 1 18.5472 11.423 14.9732 18.3726 -20.3084 16.0571 -488 2 18.105 11.7915 14.2257 -13.2839 12.4126 -20.1368 -489 2 18.4564 12.0929 15.6514 -4.79118 8.10765 5.85542 -490 1 7.00881 9.27577 7.32015 -11.3868 -9.38104 -0.512081 -491 2 6.68278 8.41602 7.64312 1.53223 10.0212 -0.264373 -492 2 7.94615 9.16913 7.19167 13.4366 -2.83724 0.374421 -493 1 18.3388 15.3149 12.278 7.79295 4.11927 0.907342 -494 2 0.562248 15.7272 12.1255 -3.32497 -4.13752 -3.12696 -495 2 17.7171 15.7348 11.6722 2.18188 4.14775 -1.5511 -496 1 16.4968 4.40066 5.28798 -9.94208 -5.06851 -0.773295 -497 2 16.7853 4.2225 6.18546 2.9967 -3.39819 7.99443 -498 2 17.2662 4.33461 4.72457 15.1936 4.75592 -3.34352 -499 1 17.7173 3.18772 10.7866 10.4448 7.42964 -1.18609 -500 2 18.6422 3.37989 10.9855 -1.52891 3.674 4.44234 -501 2 17.7488 2.39891 10.2588 -4.04978 -15.6839 -7.32077 -502 1 12.3149 18.6145 10.0881 -2.22129 4.11252 3.54852 -503 2 11.4444 0.333084 10.2939 -3.02626 -1.86973 1.00626 -504 2 12.9201 0.705852 10.2372 4.71846 0.03299 -1.96706 -505 1 10.3684 9.76179 12.4758 17.9734 4.74974 2.50525 -506 2 11.1916 9.84607 12.9926 -11.8304 0.187235 -1.96375 -507 2 10.3012 8.81681 12.3218 -3.77483 -3.01576 0.0814472 -508 1 0.689392 2.74058 7.08104 -5.98449 10.1616 9.8561 -509 2 0.88859 3.44563 7.72485 0.581102 -9.26818 -8.93017 -510 2 0.974446 1.93578 7.5088 2.3916 -6.77547 7.05728 -511 1 0.277472 15.3259 6.84135 0.228059 -1.31559 -11.5462 -512 2 0.516029 15.5821 7.71821 6.50181 -1.47438 23.8891 -513 2 0.58839 14.4222 6.74639 0.679055 -1.95969 -5.2972 -514 1 17.0529 6.97528 15.0633 10.9144 -7.53558 1.72506 -515 2 17.8201 7.55974 14.9678 -6.11827 1.26888 -1.51964 -516 2 17.4266 6.16431 15.4413 -5.39729 2.11926 -0.659196 -517 1 9.11957 12.4732 8.03484 -32.1356 7.88594 4.6652 -518 2 9.41535 11.8783 7.35952 15.5672 -13.5118 -9.19924 -519 2 8.15954 12.512 7.86156 14.5216 4.72308 9.92056 -520 1 1.18275 1.7303 2.88012 3.13258 6.74516 -6.07855 -521 2 0.990874 2.23802 2.08159 -8.2151 -5.8717 0.0306137 -522 2 1.74436 2.31191 3.39299 4.34337 2.29394 9.11202 -523 1 4.11863 15.0886 9.98721 11.0177 -1.77256 -13.134 -524 2 4.02022 15.2012 9.03136 -3.58336 0.815549 3.23991 -525 2 5.04995 14.8741 10.1041 0.462863 -2.8957 0.615957 -526 1 7.38268 2.21023 14.7219 2.37064 11.9314 4.06902 -527 2 7.04717 1.62795 14.04 0.302375 -0.796384 -5.36483 -528 2 7.78873 2.97247 14.2654 -8.69617 -12.215 6.09363 -529 1 18.4343 14.5687 2.16054 8.35658 -0.618946 0.782777 -530 2 0.682906 14.919 2.34098 -12.2336 -1.59186 -0.620803 -531 2 17.7977 15.2902 2.22089 3.32879 4.73949 -0.959115 -532 1 10.0087 2.72001 12.9057 2.08485 -1.52945 -12.9938 -533 2 10.0412 2.17732 12.096 -1.38389 3.39971 12.264 -534 2 9.25575 3.30628 12.7713 -2.15732 -0.406341 3.704 -535 1 2.9831 8.88024 13.0189 0.952466 11.8173 -3.08609 -536 2 3.31938 9.77893 12.8076 -5.04245 -14.2298 4.61688 -537 2 3.71596 8.41411 13.4449 -4.1112 -0.429279 -5.2011 -538 1 3.20203 8.5912 3.76846 -11.4045 -12.6583 26.9753 -539 2 3.76961 9.22975 3.3591 6.50161 14.1888 -13.0281 -540 2 3.15464 8.85629 4.71231 4.40411 -9.17072 -19.7321 -541 1 5.64764 7.22249 8.60582 -2.45044 -0.628932 2.27153 -542 2 5.55364 6.27099 8.49955 3.15339 -1.29251 -2.67256 -543 2 4.90409 7.47651 9.17344 9.24373 2.45699 -1.73114 -544 1 14.907 1.53023 1.85078 -7.37767 -15.1485 8.29721 -545 2 14.668 2.24872 2.45072 11.5035 7.56218 -5.89301 -546 2 15.6059 1.77377 1.2289 -9.91057 9.46649 1.95684 -547 1 8.55561 15.0845 0.759561 -2.78586 4.97755 1.3099 -548 2 9.2232 15.1059 1.46635 -5.75771 -3.12613 -8.68727 -549 2 7.79979 14.5909 1.11068 3.03755 -1.08449 1.22088 -550 1 15.5064 1.39564 7.20176 -2.04619 -6.07348 -4.735 -551 2 14.846 0.870461 6.73047 4.3658 -0.949999 1.00211 -552 2 15.0733 2.23713 7.35024 -3.19526 7.79987 5.63196 -553 1 4.99693 12.9582 18.4618 -8.43591 -3.95032 12.7964 -554 2 5.427 12.9558 0.691187 -3.21166 1.68806 -6.66553 -555 2 5.5701 13.4759 17.8974 6.4766 -1.03013 -3.5001 -556 1 15.3823 8.61159 18.0651 4.42877 2.22092 -6.07372 -557 2 15.8154 9.23321 17.4587 -2.51695 -7.00562 1.90652 -558 2 15.1591 9.14089 0.186524 -1.03798 5.78876 7.10622 -559 1 12.0334 3.10844 18.3299 11.3082 -20.8993 7.10454 -560 2 12.3341 2.61645 0.471712 -7.66483 12.171 -5.21514 -561 2 12.3614 2.54753 17.6085 -4.58122 9.25845 0.807451 -562 1 13.192 12.7001 5.16537 5.21593 -6.7049 -2.26257 -563 2 13.6127 11.9331 4.74049 -3.39065 6.67562 5.25333 -564 2 13.2679 12.5364 6.11315 0.126366 6.17512 0.133491 -565 1 6.11282 7.21918 0.158665 1.88014 -14.5403 11.0752 -566 2 6.12514 8.17662 18.815 -2.86446 -0.617519 -0.818148 -567 2 5.41227 6.95692 0.781338 0.907384 -1.18964 -10.3034 -568 1 17.7111 15.8907 14.9544 -3.82577 1.28333 3.96962 -569 2 16.7386 15.9987 14.9233 18.3395 -0.0507343 -6.61585 -570 2 18.0408 15.7242 14.0577 -12.1828 1.42979 -0.226855 -571 1 13.1366 0.926204 16.6604 -4.9212 9.87611 -1.92759 -572 2 14.096 0.89187 16.7156 4.29984 -5.34206 5.94224 -573 2 12.8563 0.0335376 16.4436 -2.56348 -3.63873 3.02874 -574 1 10.9184 14.5253 7.38829 1.38398 -2.03118 7.00079 -575 2 10.1136 14.2278 7.85844 13.304 -1.52714 -8.95405 -576 2 11.6006 13.8396 7.51991 -9.17062 7.88742 -1.04716 -577 1 17.6363 8.46247 2.12178 -2.04395 4.31685 9.18728 -578 2 16.787 8.41765 2.58806 4.70486 1.56362 -5.63911 -579 2 17.6123 7.75928 1.47082 0.631216 -3.65047 -4.17578 -580 1 12.4375 7.79355 2.00637 -2.34281 23.5579 2.73553 -581 2 11.9501 8.63365 1.95534 8.51098 -6.49732 1.55884 -582 2 12.0343 7.24559 1.33225 -2.11395 -7.52965 -2.88654 -583 1 12.0451 14.5968 10.4885 2.58602 -10.5702 -25.2135 -584 2 12.3016 14.3716 9.56719 -0.183055 2.34539 21.1217 -585 2 11.1058 14.7694 10.4266 -10.5567 0.791778 1.58055 -586 1 6.78603 6.87835 15.4866 -3.36028 4.68136 22.1121 -587 2 7.71026 7.02894 15.2668 2.14313 -2.1467 -3.22881 -588 2 6.63472 7.41247 16.2893 -0.664868 -8.24615 -12.946 -589 1 7.99755 4.5041 13.3499 24.8278 34.1767 5.68201 -590 2 7.17338 4.66838 12.8997 -9.34484 -1.26894 -9.57598 -591 2 8.42297 5.40326 13.4231 -14.2483 -32.2403 1.51042 -592 1 13.3614 12.2059 14.3726 -2.68828 -3.01756 -2.25781 -593 2 13.124 11.2722 14.2967 -0.0467593 -0.437755 2.8377 -594 2 13.7081 12.4264 13.5024 2.10157 3.54991 -1.69903 -595 1 14.5654 9.5448 7.2719 7.4337 1.87458 1.84958 -596 2 15.4192 9.97446 7.42049 -0.421966 -1.69006 0.109976 -597 2 13.9603 9.96019 7.88547 -6.00597 1.06642 2.40823 -598 1 12.7021 16.8399 3.28406 2.1329 2.22559 -4.89416 -599 2 12.9627 17.2776 4.09814 -1.16793 0.633127 5.57798 -600 2 12.5029 17.5595 2.67417 -2.21511 -1.15635 -1.62469 -601 1 1.01088 7.06774 17.3689 20.0897 -7.47151 2.1243 -602 2 0.171968 6.83932 17.7636 -13.4375 4.7826 3.09836 -603 2 0.861358 7.69882 16.662 -3.49993 1.38105 -6.69635 -604 1 12.9265 4.90969 15.692 -1.72339 7.7777 5.20839 -605 2 13.7461 4.44088 15.8455 2.50132 -9.36464 -4.69309 -606 2 13.1831 5.83499 15.7716 0.254864 4.72294 -0.0726576 -607 1 2.3277 3.38915 5.11911 5.08689 -5.27649 -8.37414 -608 2 1.81648 3.03652 5.84872 -5.99705 -1.71944 1.12123 -609 2 2.79757 4.13118 5.49603 6.03185 12.6803 -1.33855 -610 1 8.22299 10.983 13.6596 -2.68868 6.78672 22.55 -611 2 8.37046 10.9349 14.6227 -7.71168 -0.54916 -12.6902 -612 2 9.06889 10.7219 13.2955 2.07822 -5.6604 -8.58071 -613 1 12.9566 1.54883 13.2404 -6.45532 19.0424 -4.61407 -614 2 13.4436 1.59622 12.409 4.66376 -6.5769 4.30334 -615 2 12.5511 2.44176 13.2892 3.97521 -19.3883 2.5587 -616 1 6.59697 13.6382 2.12308 -19.53 14.6785 -2.92569 -617 2 5.9569 13.9305 2.80289 7.92829 -3.31956 -9.9577 -618 2 7.23585 13.1086 2.59101 5.128 -6.56439 5.02766 -619 1 15.8657 6.47234 12.6041 4.99369 -6.06314 4.28807 -620 2 16.4551 6.98041 12.0348 -2.62867 1.80518 0.0955392 -621 2 16.3109 6.45259 13.4696 -4.62358 3.40022 -7.66147 -622 1 16.7868 0.706192 9.5524 8.10763 10.4692 12.0206 -623 2 16.4993 18.5236 9.95191 3.55616 -11.3811 -4.24312 -624 2 16.3059 0.843102 8.73445 -6.13335 -2.9453 -10.1224 -625 1 6.15553 11.6636 8.28166 8.04937 9.43191 -5.2183 -626 2 5.38812 11.3133 8.7152 -15.4132 0.789816 9.90132 -627 2 6.60546 10.8728 7.99206 7.62403 -6.5238 -2.76924 -628 1 2.80481 8.67956 0.357522 -16.6853 -5.97365 -15.2844 -629 2 2.27492 8.26466 18.2845 10.7138 4.85897 15.9492 -630 2 2.22127 9.36062 0.722932 4.52332 -2.29686 2.25001 -631 1 10.1103 10.3863 6.60128 -6.60242 -1.42487 -6.12592 -632 2 10.6136 9.70804 7.05871 2.40377 -4.05953 3.76861 -633 2 10.2954 10.2785 5.66001 4.13032 2.32994 2.59513 -634 1 6.85077 15.7563 6.70738 -11.7521 -4.07497 3.77538 -635 2 6.99262 16.2462 7.53077 3.71638 -1.24183 -4.26209 -636 2 6.92978 16.3894 5.98454 6.68147 0.141382 -0.214337 -637 1 6.48958 12.9529 5.78988 1.80967 -1.32299 -1.48619 -638 2 6.5811 13.8382 6.15183 4.24501 4.33378 1.70513 -639 2 6.11675 12.413 6.49523 0.159424 2.05888 1.44919 -640 1 16.7629 12.5191 9.71336 -1.62109 -11.3708 1.97787 -641 2 17.0324 11.8284 9.09183 -7.38478 2.50021 2.06117 -642 2 17.4395 13.1763 9.61316 3.98731 12.5093 -0.628579 -643 1 6.20997 2.89816 2.77935 -0.0802363 -5.63791 0.773513 -644 2 6.61167 3.74714 2.54082 -9.15989 -2.58724 -3.98308 -645 2 5.63039 2.60429 2.05445 8.60419 4.25286 3.07741 -646 1 10.7636 3.09526 3.23748 -2.12809 -1.19847 1.63085 -647 2 10.0581 3.70038 3.49376 4.9418 2.80865 -0.749542 -648 2 10.4122 2.60071 2.48751 -0.504171 1.44253 0.108713 -ITEM: TIMESTEP -80 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.8014 6.74321 17.9894 -25.71 0.163943 4.88408 -2 2 7.93592 6.85831 18.4426 18.3019 -2.2716 -9.29 -3 2 8.62145 6.12739 17.2721 4.06901 -0.284928 0.869098 -4 1 0.193099 8.36013 6.75275 5.74913 -14.5769 25.1987 -5 2 0.349094 8.05034 5.86501 -0.249861 0.708817 -17.2091 -6 2 0.558161 7.64099 7.32168 -7.5605 18.9357 -7.69302 -7 1 8.61156 0.29086 6.89037 18.8351 -6.84677 1.91716 -8 2 9.54524 0.192133 6.6105 -17.2936 6.40231 3.46958 -9 2 8.24205 0.986486 6.33979 -0.485036 0.67975 -2.4356 -10 1 6.46061 1.74084 11.7563 18.0716 -9.05138 -10.6926 -11 2 5.90902 2.36746 12.1907 -18.8993 15.6687 11.8916 -12 2 5.86943 1.07894 11.3852 -0.461453 -6.159 1.34784 -13 1 6.94761 5.53992 2.37529 -6.07193 26.0011 19.9509 -14 2 6.56484 5.89454 3.23997 6.76459 -12.0871 -41.8379 -15 2 6.81469 6.2225 1.67437 0.333839 -16.9501 17.8189 -16 1 16.2464 10.2212 16.095 -30.9636 -1.96085 19.7441 -17 2 16.8891 10.4896 15.4774 30.9665 9.88757 -18.0257 -18 2 15.7638 11.031 16.3423 6.62567 -11.9253 -3.68232 -19 1 10.7594 14.9468 2.28506 -10.192 -15.3258 -5.27915 -20 2 10.552 14.3194 2.98639 5.50444 -0.296801 2.35986 -21 2 11.1642 15.6696 2.7411 11.3222 17.7739 6.10774 -22 1 17.1862 8.22111 10.8759 16.4539 0.643281 -9.91552 -23 2 16.576 8.81969 11.3105 -3.64966 6.67804 4.28607 -24 2 17.949 8.77387 10.614 -8.44523 -5.92405 1.0378 -25 1 14.6358 16.0024 16.3895 25.5058 -11.0228 4.42293 -26 2 13.7352 16.2786 16.3126 -22.3429 5.97271 0.576342 -27 2 14.7081 15.5263 17.2386 -3.54281 4.69451 -12.0743 -28 1 12.1273 13.3164 0.564829 -0.361627 4.24339 0.0908299 -29 2 11.7754 13.443 18.3303 1.85705 -5.04776 -15.4247 -30 2 11.6653 13.9884 1.07404 2.42612 -1.45379 10.2607 -31 1 9.30563 5.48822 3.87958 6.5447 0.0363683 25.4904 -32 2 8.87806 5.40536 4.77034 1.54217 -0.907852 -25.4465 -33 2 8.62277 5.52424 3.19838 -5.81373 -1.17005 3.72822 -34 1 1.59219 3.96918 11.5778 -9.84269 42.1113 -23.7424 -35 2 1.65598 4.94531 11.7448 -5.32168 -23.4604 1.30407 -36 2 2.08682 3.52502 12.2368 16.8537 -14.859 24.6718 -37 1 2.0876 6.92307 8.18563 -3.73767 -8.57072 -0.0346284 -38 2 2.39381 7.30463 9.00964 5.23298 7.68032 1.6714 -39 2 2.09597 5.97338 8.35948 -3.7573 0.82597 0.238295 -40 1 5.28961 4.49122 7.85762 -5.23337 8.41869 1.15392 -41 2 5.42981 3.54006 7.92701 -4.09922 -6.37036 -7.26013 -42 2 4.64396 4.70759 7.15783 7.0556 -5.183 4.67383 -43 1 3.36027 2.89954 17.3915 -17.4395 12.4687 22.0366 -44 2 4.05476 3.43419 17.006 5.24509 0.828911 -8.29254 -45 2 2.77379 3.5226 17.8911 18.871 -11.3769 -11.5396 -46 1 7.49453 5.42535 6.18785 1.1565 -0.337813 22.5495 -47 2 7.9164 5.96716 6.90215 -9.87324 -14.4944 -23.4171 -48 2 6.89327 4.79051 6.63979 12.0833 17.318 -7.46699 -49 1 9.81909 7.02563 12.0706 7.31099 -1.858 8.99458 -50 2 10.1534 6.27284 11.5881 4.21769 -4.6772 -1.38273 -51 2 9.09614 7.33889 11.5389 -11.6555 6.63577 -10.586 -52 1 13.987 3.72336 8.09074 -16.8343 16.962 -37.2017 -53 2 13.5442 4.52839 7.7245 12.4076 -19.615 9.33911 -54 2 14.2201 3.91921 8.97962 7.00657 7.67382 26.2916 -55 1 4.5104 17.1281 3.91533 10.7578 31.6451 -21.4766 -56 2 5.3439 17.6347 3.91183 -5.56531 -14.4645 11.3324 -57 2 4.01019 17.58 3.20396 0.717673 -14.6313 13.083 -58 1 16.3456 16.5752 10.4878 9.47486 -6.83722 -28.8723 -59 2 15.5139 16.524 10.9378 -17.3385 1.90191 12.1775 -60 2 16.1667 16.1386 9.62748 3.54118 4.50203 14.5107 -61 1 1.9669 4.78352 0.127126 -0.739304 -4.30462 13.1261 -62 2 2.4124 5.1813 0.904759 -4.07407 -0.50297 -16.3737 -63 2 1.70825 5.48663 18.1668 4.40273 7.87995 3.28325 -64 1 11.3312 13.2592 16.4181 -1.15069 -16.7597 -15.9919 -65 2 10.8158 12.4247 16.4648 10.4615 17.429 3.38388 -66 2 11.9137 13.1122 15.6483 -5.75273 4.84583 10.0297 -67 1 10.0951 10.9476 16.7865 12.4257 -21.5163 1.40398 -68 2 10.4762 10.0399 16.7888 -6.98476 25.4172 2.00859 -69 2 9.15392 10.8219 16.7533 -12.5538 0.302602 -1.38706 -70 1 11.8287 17.486 13.4829 -0.118354 -13.6364 7.15806 -71 2 12.4458 16.8683 13.0504 -5.40922 13.24 -3.88075 -72 2 12.1685 18.3769 13.3708 4.2975 6.3924 -3.60834 -73 1 6.40329 9.45666 12.3007 7.59953 -15.5921 -26.3915 -74 2 7.02951 9.14458 11.6116 -13.6176 6.52201 11.0115 -75 2 6.95635 9.88774 12.9378 9.38595 10.7935 13.1394 -76 1 16.3024 12.9052 2.74142 -15.9403 -16.7132 8.77179 -77 2 17.1501 13.3041 2.5727 9.16723 7.57391 -3.15506 -78 2 15.6647 13.6204 2.85813 1.6204 2.22565 -2.39426 -79 1 0.760847 12.751 5.87222 -24.7031 -12.948 -13.3423 -80 2 1.12648 12.6956 4.9713 -1.82207 2.12621 9.26767 -81 2 18.4428 12.5289 5.74368 26.1358 12.2861 6.31515 -82 1 5.29492 16.3822 18.4146 -5.77927 -1.1636 -2.25588 -83 2 5.45161 15.4933 18.0434 4.5004 13.3336 10.181 -84 2 5.72207 16.4863 0.6292 0.349856 -6.54957 -3.00829 -85 1 0.672446 7.71977 4.17015 11.9206 5.83738 -2.65809 -86 2 0.0599114 7.99601 3.47788 2.17241 0.0211014 0.560686 -87 2 1.51354 8.18303 3.96741 -13.409 -12.9126 0.0558484 -88 1 3.18041 9.04016 6.47644 -48.733 9.26031 0.132627 -89 2 3.67612 8.69495 7.19851 13.8171 -10.3779 15.348 -90 2 2.22175 8.86945 6.71565 32.4894 5.10639 -10.1715 -91 1 7.33809 10.425 16.1982 -13.7714 -1.76245 23.4597 -92 2 6.52669 10.798 15.8343 6.52641 -1.5478 0.375626 -93 2 7.11414 10.2397 17.1395 3.58358 2.1532 -21.3577 -94 1 11.0368 0.910412 5.00755 -5.03762 -2.37072 -20.9965 -95 2 11.0166 1.76948 4.5572 3.99116 -0.122414 9.27702 -96 2 10.8085 0.318039 4.26499 2.41704 1.78329 12.9529 -97 1 4.27055 2.90822 13.1584 -5.03414 2.69466 11.7405 -98 2 4.39065 3.48249 13.9384 2.16314 -12.4788 -5.29849 -99 2 4.11656 2.00207 13.4974 4.2297 10.0998 -5.7581 -100 1 8.47529 10.248 1.79037 -0.416679 -17.2671 7.19176 -101 2 8.23967 10.8662 2.49257 2.8179 1.08296 2.51337 -102 2 8.59639 9.37915 2.23271 0.0130336 16.1865 -5.8343 -103 1 10.3383 1.70852 15.4843 -18.7352 2.46602 -2.29408 -104 2 11.1863 1.36274 15.7269 17.9639 -3.17473 -1.31836 -105 2 10.261 1.74525 14.5183 4.02029 2.26456 4.98686 -106 1 2.61381 12.97 7.91629 0.377646 -9.00714 -10.2558 -107 2 3.20736 13.521 7.38885 -1.73045 4.27865 2.80704 -108 2 1.92972 12.6563 7.30106 5.76016 2.06086 0.889789 -109 1 3.8265 11.6489 4.94253 -18.049 0.292651 15.0893 -110 2 3.64515 11.1228 5.74952 0.240622 6.04317 -17.8646 -111 2 3.00147 11.7074 4.41136 14.7829 -0.870145 11.9003 -112 1 6.67003 14.5068 16.9871 0.195301 -8.52391 -8.20479 -113 2 7.30673 15.1853 17.2075 3.81359 1.00594 1.02421 -114 2 6.51415 14.5784 16.0351 -3.74805 4.58221 3.23833 -115 1 14.2005 14.4991 3.2542 12.2104 -4.1759 -13.149 -116 2 13.9664 15.4191 3.35064 -8.52353 7.22912 -0.280994 -117 2 13.8358 14.0368 4.00136 -6.61808 -5.66537 10.7242 -118 1 8.64986 18.0488 16.0994 -35.3958 -9.60596 -0.188096 -119 2 9.08138 17.255 16.4541 14.3634 13.9351 -5.51429 -120 2 9.16615 0.19969 15.9552 18.9441 -0.541676 3.30098 -121 1 4.69447 1.75392 4.88991 25.859 26.3088 -12.7751 -122 2 3.87089 2.24691 4.93296 -3.58784 0.203107 2.94233 -123 2 5.32887 2.35869 4.40805 -22.2668 -23.8988 10.2256 -124 1 15.0337 12.5563 16.5322 -9.42235 19.0778 45.1845 -125 2 14.5415 12.8308 17.3429 25.2588 -5.91919 -13.7907 -126 2 14.3516 12.6025 15.8912 -15.7131 -4.7436 -33.7881 -127 1 15.7107 18.4933 16.8499 14.0119 15.6823 26.0515 -128 2 16.2364 18.5256 17.6977 -11.7154 -4.95338 -28.5838 -129 2 15.2517 17.6535 16.8181 2.70767 -12.4638 1.72062 -130 1 1.36288 1.31672 16.6317 -8.11361 12.6727 12.78 -131 2 2.12452 1.88684 16.8387 -7.41596 -12.3761 -6.73343 -132 2 0.666274 1.64987 17.2352 10.0682 -8.10993 -10.4284 -133 1 18.2119 4.36953 15.9172 -1.70541 -5.24792 -22.7614 -134 2 17.9042 3.81192 15.1707 6.44647 9.66147 16.3107 -135 2 0.476259 4.62247 15.7042 -5.76089 -2.38794 2.9761 -136 1 12.1484 17.0613 16.1489 -25.1744 -26.2572 32.1897 -137 2 11.4087 16.4938 16.5203 28.1495 25.8696 -8.33389 -138 2 11.9925 17.0682 15.2174 -4.06343 5.18838 -23.7308 -139 1 16.1307 2.63053 18.236 -24.4255 7.46546 -12.7341 -140 2 15.654 3.45006 18.4862 10.3096 -12.6534 -4.96798 -141 2 15.8825 2.42572 17.3162 0.942238 5.76458 9.76029 -142 1 6.69125 13.7819 10.0957 6.51523 5.30674 14.72 -143 2 6.68166 13.4115 10.9958 -3.31201 0.605957 -8.104 -144 2 6.74207 13.0463 9.48799 -5.76864 -9.77159 -4.40801 -145 1 10.1909 18.4566 2.69612 24.6552 12.5235 -11.9688 -146 2 10.5208 0.299966 1.90483 -6.63917 -6.88653 20.5003 -147 2 9.33855 18.1401 2.45819 -23.0922 -9.86885 -6.30041 -148 1 3.05041 17.6833 6.1612 -20.7399 0.346779 9.3758 -149 2 2.11766 17.6882 5.81771 32.7543 -5.44367 1.96306 -150 2 3.663 17.6288 5.4193 -6.60477 0.357372 -5.21379 -151 1 12.6301 16.8021 7.91443 2.73044 3.22351 -7.20597 -152 2 11.8394 16.2829 7.68186 3.48899 3.70212 12.2186 -153 2 12.4619 17.4281 8.63963 -10.075 -5.48551 -5.536 -154 1 14.8863 15.2402 8.20999 -23.6436 14.8183 29.3151 -155 2 14.1404 15.8836 8.27066 14.7388 -14.8318 -6.56535 -156 2 15.2763 15.3549 7.35467 9.52302 6.19548 -12.651 -157 1 17.8321 18.2493 0.273835 -34.2521 -9.59248 -4.32979 -158 2 18.5224 17.6645 -0.0392514 10.753 2.02465 3.4369 -159 2 18.2087 0.412934 0.595185 14.0613 13.0178 4.00109 -160 1 0.763956 10.5262 1.39925 -10.0074 -57.9186 33.1602 -161 2 0.0205775 9.86382 1.5781 27.9288 29.6193 -5.5527 -162 2 0.446448 11.1766 0.811593 -14.5912 25.5328 -23.4764 -163 1 1.80037 12.2889 3.30512 5.17734 11.597 19.2466 -164 2 1.46139 11.5987 2.74824 -6.10095 -9.75588 -16.5262 -165 2 2.13675 13.0044 2.75129 -3.9772 -2.70365 -1.85909 -166 1 0.682885 17.2588 4.99366 18.5034 24.5267 -32.7679 -167 2 0.107172 18.0117 5.16246 -8.54671 -5.12892 6.2039 -168 2 0.50047 16.4742 5.48014 -13.5055 -14.6224 21.6265 -169 1 1.0645 0.823506 9.34737 11.8193 5.83131 5.68962 -170 2 1.36557 0.594309 10.2448 -8.52979 0.55273 -0.975829 -171 2 0.153783 0.559257 9.28231 -13.2671 -5.76719 2.40467 -172 1 16.771 2.35127 13.3608 4.58635 29.8799 -13.6101 -173 2 16.8279 2.7166 12.4388 1.57782 -15.3367 24.752 -174 2 16.4858 1.44141 13.3191 -2.28737 -11.3359 -2.05688 -175 1 2.68433 15.9539 12.0479 2.00481 -8.12072 21.99 -176 2 2.97356 15.5639 12.9056 -4.45908 8.74231 -22.8774 -177 2 3.1524 15.4962 11.3314 -4.16555 3.83231 7.28649 -178 1 16.3902 15.5703 6.15458 18.8333 21.1033 -24.533 -179 2 17.3221 15.5371 6.43733 -15.6071 -4.56317 -0.523174 -180 2 16.3697 16.3474 5.53712 -7.15193 -24.3314 15.8574 -181 1 5.78808 5.16844 11.811 1.07675 -5.38543 -7.05048 -182 2 5.68145 6.03537 12.2081 -3.48533 4.06917 4.5041 -183 2 5.0592 4.65006 12.1655 2.16361 -4.54815 -2.94322 -184 1 15.172 4.89144 0.795633 -0.620892 -0.594882 26.39 -185 2 14.9156 4.81116 1.75201 7.19669 -4.64536 -26.7766 -186 2 14.3985 5.20255 0.336699 -8.8444 5.20324 -3.46854 -187 1 16.3986 16.4119 1.90339 15.122 14.6556 -26.5352 -188 2 16.0454 16.7612 2.71133 -6.27107 5.29423 17.303 -189 2 16.8063 17.1873 1.44657 -8.45441 -18.3773 8.08233 -190 1 0.184762 4.82044 3.92309 -20.0167 36.2337 -7.4234 -191 2 0.305381 5.80234 3.92557 1.42835 -23.0136 0.864842 -192 2 1.01251 4.4465 4.18098 17.0496 -9.16948 9.65169 -193 1 2.95853 15.072 15.1235 -0.929158 -18.0667 1.08146 -194 2 2.81752 14.526 15.9315 -1.93517 21.6459 -9.19578 -195 2 2.47159 15.9015 15.2035 -0.281788 -0.150795 8.17547 -196 1 1.08884 14.6409 9.4443 27.3966 -12.5379 -34.1186 -197 2 1.70575 13.947 9.05916 -23.9186 28.888 17.798 -198 2 0.66831 14.2301 10.1769 -7.64803 -12.9163 21.0233 -199 1 13.5173 16.5215 11.5364 0.489599 15.4909 -5.38356 -200 2 13.0836 17.2895 11.1076 8.88627 -7.75363 7.54599 -201 2 13.0704 15.7764 11.1287 -2.36322 -6.26123 2.87696 -202 1 4.73898 1.52078 0.69167 -9.68217 -10.6702 17.6377 -203 2 4.07875 2.00526 0.184075 4.46446 1.98443 -3.98397 -204 2 4.22033 0.928191 1.27988 9.48282 8.28471 -14.387 -205 1 1.52478 18.5784 11.9214 -16.2358 21.4234 -4.1613 -206 2 1.51367 0.493465 12.7143 -0.730917 -3.29007 -5.80239 -207 2 2.22048 17.951 12.0321 13.8924 -17.5303 6.45556 -208 1 11.4148 10.1041 4.08036 9.63761 14.6797 -7.17105 -209 2 11.6092 10.6619 3.28786 -9.14527 -18.7957 16.2306 -210 2 12.2661 9.96891 4.5224 -0.931524 1.73008 -8.63915 -211 1 8.18373 12.2132 3.70486 4.04638 8.18109 41.2935 -212 2 9.0456 12.58 3.98139 -6.62274 -6.35725 -9.04284 -213 2 7.64552 12.2934 4.54 8.66084 -3.68417 -28.5646 -214 1 14.5934 4.00277 3.33714 14.4882 6.32576 -0.110592 -215 2 15.3087 4.27672 3.93937 -11.245 -6.6719 -0.591331 -216 2 13.7777 4.36055 3.68688 -6.37652 3.17854 3.04506 -217 1 5.71814 1.6621 7.57513 -5.5313 -4.02265 40.0153 -218 2 5.00295 1.12677 7.97081 8.59667 7.25176 -1.51046 -219 2 5.48447 1.71188 6.6706 -7.03261 -0.519715 -37.0679 -220 1 17.8819 0.996597 4.84385 3.28334 1.22129 -8.70029 -221 2 18.3735 1.40853 4.10428 -5.78677 -2.02928 14.9184 -222 2 17.7642 1.64161 5.55539 2.20556 -0.0657175 -7.03701 -223 1 6.81886 9.28778 4.52861 6.25722 -6.76526 -10.2791 -224 2 6.61832 9.39383 5.45723 -0.00817066 1.76549 8.49843 -225 2 7.7574 9.04758 4.4954 -4.05712 -0.0763234 -2.03313 -226 1 2.4854 14.759 2.04442 -7.64745 -7.92423 -28.9185 -227 2 3.31932 14.7218 2.51092 7.63377 -1.04104 5.23896 -228 2 2.65881 14.5612 1.09422 1.17207 5.04057 23.1132 -229 1 17.2643 12.9213 13.1026 -19.9619 15.9168 2.25648 -230 2 16.3761 13.2301 13.4207 25.7036 -1.66639 -12.6722 -231 2 17.7779 13.7212 12.8621 -11.3949 -9.92691 5.05246 -232 1 14.8558 10.5579 1.44832 -24.1837 -11.6243 -0.0449549 -233 2 15.2498 11.3496 1.79784 9.85962 12.147 5.79114 -234 2 13.9164 10.5877 1.7065 14.7293 1.68269 -5.02708 -235 1 5.67033 6.62258 4.57309 8.95784 -16.3381 4.76769 -236 2 5.78141 7.53495 4.33529 5.34224 19.3995 0.612293 -237 2 6.44538 6.37316 5.11369 -12.1071 3.69782 0.132968 -238 1 8.08484 8.3464 10.3723 -2.79238 1.81559 10.704 -239 2 8.60215 8.86766 9.74634 -1.18548 0.238269 1.84293 -240 2 7.34937 7.94467 9.9053 0.580319 -4.15939 -10.1337 -241 1 13.4382 18.465 5.66883 -2.12963 -16.204 3.95429 -242 2 12.6402 0.317353 5.43723 -0.0049589 1.74147 2.86213 -243 2 13.1409 17.7635 6.28441 4.99057 13.7489 -2.35078 -244 1 -0.0389125 2.60201 0.358484 20.6019 -11.619 5.06808 -245 2 17.6744 2.57403 18.7483 8.04315 12.368 -1.45646 -246 2 0.347515 3.47455 0.194182 -8.07269 -1.54831 -1.2857 -247 1 12.9609 10.9078 9.72363 -44.1168 29.5082 -8.54535 -248 2 11.9486 10.9818 9.7709 44.2995 -10.8859 -2.13595 -249 2 13.1901 10.0051 9.91101 -8.5598 -18.2315 3.87517 -250 1 0.590645 12.1909 11.1498 11.7969 16.2942 20.6903 -251 2 18.3214 12.2032 11.4307 -13.062 -2.39731 -5.9775 -252 2 1.05781 12.4788 11.9545 1.3761 -3.96073 -11.1532 -253 1 5.19979 7.35251 13.3459 4.96104 -3.5954 0.621761 -254 2 5.77554 8.05147 13.0099 -6.36891 3.58923 -1.12306 -255 2 5.62026 7.07364 14.1664 0.643961 -0.709679 0.08133 -256 1 1.17273 6.78721 11.9743 -37.7935 -22.2758 -19.6174 -257 2 0.361865 7.16229 11.5551 20.1673 -8.51661 10.9701 -258 2 1.7013 7.51605 12.2195 19.7686 31.2325 8.39364 -259 1 15.5313 9.74152 12.3525 -7.42661 26.8763 14.1834 -260 2 15.1354 10.6339 12.1691 17.2848 -32.3992 2.44097 -261 2 15.9001 9.83422 13.2442 -4.7827 -6.0868 -10.0384 -262 1 16.5842 12.6457 5.58229 -7.58554 26.2756 -26.1768 -263 2 16.3849 13.5701 5.8413 5.71516 -14.5282 0.0223018 -264 2 16.4193 12.6729 4.60395 6.10391 -10.0799 23.5706 -265 1 6.38601 9.81704 0.0456579 -23.7849 0.890546 -8.41533 -266 2 5.51671 10.1854 0.278669 9.54818 -0.234306 -0.813632 -267 2 7.00687 10.1562 0.67255 15.5644 7.03716 17.2844 -268 1 12.2684 6.05846 4.00919 -28.2934 -33.3926 21.5663 -269 2 12.263 6.7861 3.41661 0.234348 22.4834 -18.769 -270 2 11.3224 5.76736 4.06199 25.4812 4.82389 -2.50319 -271 1 0.373791 12.8792 0.072054 -11.107 3.80906 -1.77299 -272 2 18.9015 13.5268 0.779758 -5.73011 -3.33995 1.31101 -273 2 18.3694 13.1354 18.0395 6.43374 -1.82904 2.53089 -274 1 3.55692 18.7013 8.65073 14.893 -16.0199 -12.5754 -275 2 3.38339 18.1698 7.85699 7.36237 7.58391 1.53928 -276 2 2.68044 0.23403 8.96368 -11.3363 8.83032 5.06178 -277 1 7.32525 17.3963 4.4514 17.4309 29.7426 -3.23332 -278 2 7.82401 18.2131 4.74166 -23.0386 -26.7058 -8.39786 -279 2 7.43189 17.3694 3.48275 -1.39589 -2.42936 11.5599 -280 1 9.26525 17.1572 12.169 8.13396 -3.40366 20.592 -281 2 9.29678 16.2438 11.8433 -0.925088 7.81756 -3.33389 -282 2 9.96734 17.2329 12.8546 -10.0311 -2.0771 -17.5408 -283 1 13.2786 13.1508 8.01112 -12.5044 -28.1533 13.0431 -284 2 13.4287 12.5256 8.7581 -3.83031 10.1919 -19.0767 -285 2 13.9208 13.8439 8.10408 14.3758 9.62768 2.82629 -286 1 14.7717 2.95063 15.4663 23.0059 6.37496 -12.5686 -287 2 14.1149 2.31 15.1961 -5.56432 -5.96018 -2.11564 -288 2 15.3514 3.08539 14.6861 -8.35989 -8.63193 12.4086 -289 1 9.95789 15.6422 16.9764 -4.46993 0.793564 -8.8018 -290 2 10.2307 14.8148 16.5569 1.31144 -2.42354 4.42353 -291 2 9.44172 15.4 17.7473 1.0906 -3.95706 9.45227 -292 1 11.2531 8.54113 16.6333 5.17657 0.0418295 -8.84929 -293 2 10.6325 8.00272 16.1399 -5.6117 -5.11655 -0.169214 -294 2 11.5912 7.9918 17.3372 0.751532 -6.83429 5.96975 -295 1 4.09617 18.2775 16.8038 -1.75476 28.7193 2.74196 -296 2 4.5979 17.7227 17.3968 3.26159 -10.0112 3.6984 -297 2 4.13851 0.526798 17.2077 -3.53746 -18.1625 -9.44923 -298 1 2.30039 4.26982 8.91686 21.6694 -5.11589 23.5763 -299 2 3.26852 4.19272 8.75344 -21.2665 0.643644 3.82423 -300 2 2.17319 4.0769 9.88449 2.25335 4.47185 -28.5355 -301 1 9.91449 10.4045 9.82138 -1.36818 12.3774 -23.5261 -302 2 9.54718 11.2486 9.48103 5.13969 -13.6804 7.80682 -303 2 9.93694 10.4191 10.7736 0.214264 3.33848 13.7587 -304 1 9.74784 0.927945 10.8307 17.8645 8.52415 0.395599 -305 2 9.30432 0.217271 11.2949 -5.1784 -7.81016 -3.03012 -306 2 9.13824 1.32484 10.1982 -3.45577 -3.9008 2.04599 -307 1 9.17195 15.1281 10.2005 -15.5022 -1.44929 -2.09464 -308 2 8.96814 15.9769 9.77108 -2.08214 -7.76738 2.59404 -309 2 8.35001 14.5895 10.1068 18.2617 13.451 2.66111 -310 1 0.828362 9.74081 10.2167 22.8302 -4.53826 -35.6406 -311 2 0.863435 10.6794 10.4661 0.846835 -12.3508 -3.07098 -312 2 1.42185 9.63122 9.40918 -26.8549 6.26386 38.0517 -313 1 17.1622 4.86379 8.08044 2.41554 -11.1764 16.204 -314 2 16.3163 5.29453 8.26848 4.74994 -0.845127 5.21041 -315 2 17.4172 4.31929 8.8662 -8.72341 14.5987 -22.1578 -316 1 14.8039 14.6747 0.0449816 -17.091 -7.62196 19.0468 -317 2 15.3137 15.169 0.695817 3.50252 1.08273 0.82912 -318 2 14.0068 14.3765 0.533797 12.6241 2.78049 -10.2188 -319 1 3.85026 11.0642 9.5563 -2.44831 7.24975 -16.8488 -320 2 3.90516 11.4403 10.4374 -3.64435 1.57263 7.30128 -321 2 3.45144 11.7342 8.96857 -1.60708 -4.46554 10.9787 -322 1 11.3552 10.7376 1.50363 23.7004 17.8717 -7.90317 -323 2 11.5499 11.5913 1.05012 -4.60225 -16.5984 9.56505 -324 2 10.4091 10.6312 1.49605 -14.4596 -0.264671 -3.06241 -325 1 13.1456 7.20328 12.6021 -24.9249 -2.39855 5.22786 -326 2 14.066 6.96941 12.5913 17.2615 -6.20786 -1.13088 -327 2 12.6433 6.37391 12.7221 9.22616 8.00521 -2.5813 -328 1 9.63635 1.93928 0.908954 12.9918 3.25798 9.3487 -329 2 8.80616 1.72326 0.497356 -10.689 -0.461065 -8.23177 -330 2 10.2384 2.2422 0.224542 -0.105661 1.67982 -4.44056 -331 1 10.6547 13.4406 4.52244 4.65594 3.65244 26.3326 -332 2 11.5391 13.0824 4.73514 -13.2197 2.26822 -8.08889 -333 2 10.4444 13.96 5.32492 0.722291 -5.69425 -12.9779 -334 1 14.5068 1.61853 10.9473 1.56188 14.5139 4.90111 -335 2 15.3059 1.27791 10.528 -0.453964 2.70191 1.23402 -336 2 14.6742 2.57144 11.1203 -1.66622 -13.4066 -10.2612 -337 1 14.4999 12.0198 11.6401 -20.4 4.4823 -10.6844 -338 2 15.1901 12.5044 11.1683 0.00955556 -6.20474 -4.10181 -339 2 13.88 11.6279 10.9736 17.9431 15.8984 14.8698 -340 1 8.17874 5.12415 9.82106 -30.5984 10.5693 18.9492 -341 2 7.28241 5.07355 10.2519 27.6442 5.22023 -11.9731 -342 2 8.30253 4.26697 9.4335 2.62166 -17.6444 -4.58757 -343 1 1.47714 16.9429 18.4887 13.3148 33.7663 -28.6254 -344 2 1.86682 17.2437 17.6257 -9.89818 -8.00998 25.1444 -345 2 1.74527 16.0479 18.574 6.31239 -26.8006 -0.778427 -346 1 1.45374 17.3594 15.3268 42.8952 -1.15706 -0.811193 -347 2 1.42588 18.2136 15.749 -3.30828 11.7666 5.73369 -348 2 0.584657 17.0429 15.2318 -41.4551 -8.54136 -0.705167 -349 1 3.54007 5.76039 6.04888 -8.98595 6.80975 7.90297 -350 2 3.01039 6.43039 6.5207 7.85999 -10.8756 -2.65394 -351 2 4.1622 6.27284 5.52252 1.18276 -3.83664 -2.43702 -352 1 12.5413 9.50789 14.2278 14.1386 -34.2774 -1.94842 -353 2 12.9806 8.74877 13.7665 -10.1246 23.4373 5.48687 -354 2 12.3781 9.12309 15.104 -2.49329 10.5308 -3.54938 -355 1 4.07791 15.2392 7.05947 28.2061 -4.52306 7.60827 -356 2 3.62905 16.0551 6.82 -1.6925 3.55103 -3.37365 -357 2 5.05246 15.4367 7.04645 -25.4492 -3.49557 -3.60676 -358 1 0.767125 8.74429 15.1186 -1.35051 -1.02403 -4.71838 -359 2 0.502685 9.67668 15.1423 2.70563 -3.13172 -3.80763 -360 2 1.44028 8.65803 14.4206 -5.36892 5.64782 6.7911 -361 1 12.8556 8.29114 10.1154 40.5883 -11.1151 11.7349 -362 2 13.7543 7.93714 9.90509 -23.2563 4.30646 -4.77873 -363 2 12.8036 8.10553 11.059 -7.7965 -1.57596 0.639248 -364 1 15.3061 7.91627 3.47282 -42.6646 -27.0181 14.5138 -365 2 14.4087 7.67951 3.19876 7.83283 16.2655 -25.9683 -366 2 15.288 7.37548 4.27198 30.0578 14.5578 6.00353 -367 1 17.2193 6.75387 0.0348868 -24.2654 8.60155 -9.76068 -368 2 16.7331 5.97981 0.339573 3.08011 -1.47023 2.02216 -369 2 16.4984 7.35116 18.3587 20.6605 -10.5931 7.39935 -370 1 8.96527 6.96977 7.82312 -33.6536 -16.7811 13.5927 -371 2 9.86459 7.23854 7.79988 29.8916 7.79708 0.58286 -372 2 8.85329 6.36072 8.58482 2.84704 12.8992 -8.98126 -373 1 12.4369 0.615517 1.24835 5.12967 -8.6669 -10.2958 -374 2 13.1996 1.14046 1.50868 5.63 -3.81589 5.32704 -375 2 12.6841 0.248493 0.387703 -6.12727 4.87774 5.89397 -376 1 5.63437 15.0947 14.482 15.2573 18.1506 -1.5187 -377 2 4.74012 15.1756 14.8216 -5.87791 -1.19647 -0.853033 -378 2 5.96659 16.0211 14.4028 -4.19512 -21.3346 -4.32131 -379 1 3.78146 6.44452 1.71439 -10.0957 17.3086 -10.1533 -380 2 3.36154 7.20469 1.26344 3.84289 -8.07011 2.3383 -381 2 3.80108 6.73559 2.62781 1.97525 -3.80667 6.02801 -382 1 3.89131 11.3886 12.3597 10.4858 -4.45626 -8.95185 -383 2 4.75702 11.7925 12.5217 -6.56671 -1.88331 -0.935479 -384 2 3.25208 11.9718 12.7596 -7.39976 8.19237 6.18945 -385 1 5.30831 3.87649 15.7567 -11.2019 61.1278 12.0088 -386 2 6.01892 3.27998 15.6709 29.6235 -28.0721 -9.85567 -387 2 5.7476 4.76544 15.8793 -15.8563 -28.9516 -7.19779 -388 1 14.1175 10.173 4.66017 9.40425 -19.9217 -33.2768 -389 2 14.1461 9.82294 5.54158 6.86029 -3.38102 17.8715 -390 2 14.6328 9.51646 4.11155 -16.0552 24.3993 16.1239 -391 1 7.5636 17.329 9.02789 1.81886 -5.76611 4.78707 -392 2 6.9813 17.6417 9.74433 4.383 2.36677 -11.0761 -393 2 7.91242 18.0661 8.5041 -5.60089 1.56926 3.7162 -394 1 4.54646 14.4437 3.82391 2.35855 8.70422 24.1238 -395 2 4.58695 15.3758 4.17596 -1.73775 -31.732 -9.36156 -396 2 4.50325 13.8127 4.58585 2.14298 18.0212 -18.4803 -397 1 14.2437 7.3639 15.8726 24.9361 2.31774 6.81444 -398 2 15.0991 7.30759 15.3921 -17.5628 0.546592 9.39404 -399 2 14.5002 7.74932 16.7373 -8.89015 -4.19374 -15.8798 -400 1 3.04207 18.4209 1.96748 -18.4085 17.9201 24.7102 -401 2 2.5353 17.8449 1.40649 -4.22111 -10.717 -13.4847 -402 2 2.35407 0.262093 2.48798 16.8127 -9.3976 -15.4809 -403 1 7.96924 1.62215 4.56344 31.9424 -9.467 0.421552 -404 2 7.35201 1.92948 3.90341 -1.64239 4.88827 -11.6355 -405 2 8.85795 1.52282 4.13815 -26.2226 6.52533 8.08337 -406 1 2.457 14.1626 17.6995 -18.6259 -8.83368 10.0969 -407 2 1.68725 13.6009 17.9701 23.9808 13.2635 -8.93306 -408 2 3.24279 13.6711 17.9492 9.2771 -5.34798 1.51385 -409 1 0.927142 1.91914 13.8849 28.4694 2.81528 -14.4963 -410 2 1.17928 1.66855 14.7668 -1.31862 -2.11333 16.1229 -411 2 -0.00784116 2.01924 13.8762 -26.8609 -0.0423979 -2.90492 -412 1 4.3639 0.116891 13.871 19.5154 5.98388 -10.2249 -413 2 5.3312 18.592 13.8382 -18.25 -1.84578 0.0905254 -414 2 4.09014 18.5553 14.7613 -1.68072 -4.35498 12.29 -415 1 7.32185 0.935992 18.4254 -25.1976 4.88188 40.3736 -416 2 7.29261 0.583526 17.5599 3.22929 -13.7772 -30.1977 -417 2 6.39141 0.906009 18.7671 22.6248 8.40202 -10.9225 -418 1 15.9043 18.3822 13.9598 -30.4853 6.92778 -31.02 -419 2 14.9691 18.5865 13.6701 32.1757 -7.76669 18.1984 -420 2 15.9697 -0.290473 14.9111 -4.96086 4.78357 11.6174 -421 1 10.2566 4.62301 16.2429 -20.4053 -21.3362 -19.7333 -422 2 11.1923 4.47268 16.3843 6.75918 3.74651 0.0845893 -423 2 9.94726 3.80759 15.7722 8.97755 19.5704 18.0095 -424 1 15.9188 17.665 4.49409 -30.8876 16.8748 5.69015 -425 2 16.5463 18.3904 4.38809 -0.624131 1.21894 5.03495 -426 2 15.0755 18.0798 4.84388 28.6139 -15.2662 -13.1828 -427 1 6.9464 17.5119 13.903 30.1459 16.134 14.6047 -428 2 7.45538 17.7973 14.7126 -14.438 -11.5296 -22.8133 -429 2 7.62564 17.4897 13.1926 -14.0494 -3.94126 11.1274 -430 1 13.2241 6.43487 6.53037 -11.3028 -4.49966 -3.41689 -431 2 14.1722 6.56035 6.47079 5.41657 3.67276 -3.81812 -432 2 12.8747 6.35097 5.62176 7.42053 0.356932 11.8509 -433 1 7.85865 2.26615 9.45505 -4.28533 -3.16859 -37.0089 -434 2 7.29966 2.29372 10.2234 -12.0252 -4.85104 14.2867 -435 2 7.31757 1.89726 8.71059 11.6806 10.5906 18.7024 -436 1 15.1499 14.8389 13.7285 -7.78284 7.72319 0.275575 -437 2 14.8617 14.9509 14.6481 -0.524909 3.36892 -5.65775 -438 2 14.6832 15.507 13.1912 6.48748 -10.1003 7.43034 -439 1 9.39784 8.36731 3.82962 2.5344 -9.0015 0.237957 -440 2 10.2136 8.88179 3.87227 -2.41531 -0.25237 0.330419 -441 2 9.66909 7.4454 3.98022 -9.00345 8.8328 -4.59515 -442 1 17.7291 13.5977 16.4646 5.88425 13.7422 -6.32319 -443 2 16.779 13.4368 16.4502 -3.47507 3.66531 -1.64514 -444 2 17.9175 14.4327 15.9665 -10.227 -20.4783 11.0606 -445 1 4.89529 10.4518 2.85531 35.8078 -15.8912 -9.72696 -446 2 5.76001 10.066 3.12945 -20.0856 5.21459 -7.60385 -447 2 4.65599 10.9551 3.62329 -7.19184 9.4675 7.77805 -448 1 3.68184 8.40606 9.96257 -7.06038 -13.6752 25.4145 -449 2 3.73025 9.3314 9.75201 2.05841 13.8137 -4.67922 -450 2 3.5201 8.39907 10.9276 1.35511 -1.83367 -14.7667 -451 1 15.9506 6.91676 5.90036 8.23349 -12.8437 -5.59708 -452 2 16.7283 7.39089 6.23923 -5.44721 -6.23743 -4.31526 -453 2 16.2459 6.04307 5.54881 -4.37327 20.9496 12.2757 -454 1 15.2047 7.21919 9.02648 -8.23364 16.7266 -25.0777 -455 2 16.0013 7.62239 9.37026 6.97324 -0.496136 10.989 -456 2 14.9764 7.76869 8.23928 2.79192 -13.8116 16.1423 -457 1 6.18989 12.8346 12.7303 -2.33267 17.6694 7.57139 -458 2 6.82101 12.228 13.1265 8.54383 1.14333 3.13472 -459 2 6.09938 13.6243 13.3122 2.17121 -15.6415 -7.8487 -460 1 12.1177 4.51675 13.1173 40.066 24.623 8.84127 -461 2 12.3608 4.67527 14.0558 -10.9347 -6.25445 -11.8552 -462 2 11.2865 4.0907 13.0625 -30.7168 -15.659 3.72413 -463 1 11.4382 8.09379 7.90765 11.4031 -1.65515 0.349674 -464 2 12.1555 7.64923 7.40412 -12.1024 3.57709 12.4555 -465 2 11.7306 8.14579 8.84607 -3.22191 -0.660368 -24.1915 -466 1 17.0422 10.838 7.59458 18.8696 -14.9771 -17.3127 -467 2 17.8015 10.2845 7.30277 -16.9558 5.34042 10.7777 -468 2 16.8989 11.446 6.8574 -4.66599 0.747798 1.74373 -469 1 5.2881 18.0926 10.8094 -12.0199 -6.67836 -5.57022 -470 2 4.87565 17.5902 11.533 4.52174 5.42574 -9.9319 -471 2 4.66447 18.0398 10.0548 7.40461 3.40643 11.786 -472 1 7.61349 17.4864 1.6652 -5.64906 3.24499 15.5952 -473 2 7.84327 16.7088 1.17852 12.3306 -20.6776 -4.28559 -474 2 7.74119 18.1865 1.04014 -3.89506 18.5858 -12.7246 -475 1 1.91944 12.8991 13.6003 2.94725 10.7513 13.4495 -476 2 1.49936 12.2949 14.2301 -1.35275 4.24281 -4.32331 -477 2 2.12078 13.7179 14.107 -1.08361 -15.4355 -11.6139 -478 1 9.36899 6.74386 14.7638 -2.26814 18.4847 -3.39127 -479 2 9.81478 6.02606 15.213 8.95117 -11.473 0.808352 -480 2 9.85086 6.98618 13.9577 -2.76657 -9.1339 3.81591 -481 1 15.2853 4.27459 10.7783 -6.29839 -2.79317 -1.65183 -482 2 16.2088 4.11106 10.5808 3.62417 -3.44414 3.50356 -483 2 15.3067 4.91761 11.4912 -1.69264 4.92972 1.1484 -484 1 11.3393 6.23844 0.0959214 -19.2017 -19.0623 -2.27733 -485 2 11.4465 5.27934 18.8311 9.36926 7.99257 -4.22996 -486 2 10.3892 6.29463 18.5179 14.2332 9.643 5.73673 -487 1 18.5128 11.4549 14.9487 -3.47415 -8.47336 -12.1105 -488 2 18.0135 11.8846 14.234 9.23154 -3.06455 1.62932 -489 2 18.3213 12.0172 15.6945 1.79799 8.69016 10.3557 -490 1 7.01602 9.27569 7.3226 -14.4634 -16.8581 15.1781 -491 2 6.67273 8.48369 7.80259 5.98597 16.4947 -15.5019 -492 2 7.96023 9.16216 7.29002 13.6661 -3.40194 -2.89589 -493 1 18.3593 15.3216 12.2421 14.2565 8.37053 -9.09139 -494 2 0.609114 15.6531 12.0121 -9.26774 -5.34503 6.02371 -495 2 17.7657 15.7501 11.6106 -0.96984 1.15192 3.02291 -496 1 16.5123 4.36636 5.2899 -20.1169 0.0802899 32.1896 -497 2 16.6197 4.39367 6.27015 0.689823 -6.50354 -17.1519 -498 2 17.3637 4.55338 4.93619 30.7718 -0.208347 -14.1282 -499 1 17.7452 3.18489 10.789 3.81546 21.3325 5.47337 -500 2 18.6747 3.34524 11.0396 -11.7638 -6.52287 -4.76545 -501 2 17.6832 2.38146 10.2881 5.2294 -17.628 -7.02183 -502 1 12.3161 18.6216 10.0891 7.2643 12.1904 3.38538 -503 2 11.4836 0.405415 10.3905 15.4316 -4.87983 -6.88019 -504 2 13.0526 0.636416 10.1289 -21.6037 -8.70048 2.57237 -505 1 10.3866 9.75789 12.4872 13.2725 15.9888 14.5072 -506 2 11.1625 9.86545 13.086 -15.7493 -4.39745 -10.7974 -507 2 10.2528 8.81785 12.4 2.63286 -10.7197 -2.15993 -508 1 0.710964 2.68685 7.1375 -0.1398 22.218 7.12103 -509 2 0.988905 3.47272 7.66294 -4.49485 -18.6961 -10.7978 -510 2 0.93208 1.94131 7.68754 4.63119 -8.38422 8.20051 -511 1 0.281684 15.3172 6.85959 12.828 -38.7344 -20.2135 -512 2 0.500898 15.7193 7.67574 7.5107 6.97721 30.9172 -513 2 0.662709 14.3998 6.92418 -16.2289 29.7866 -9.89698 -514 1 17.0547 6.94606 15.0133 0.165691 -3.90506 -0.393601 -515 2 17.812 7.5465 14.9118 -2.55694 -6.08978 1.76467 -516 2 17.3809 6.10212 15.3719 1.63232 8.8395 -1.4121 -517 1 9.12112 12.493 8.02809 -41.9273 18.4298 17.1595 -518 2 9.51251 11.917 7.38329 0.012751 -17.4797 -14.5944 -519 2 8.13115 12.5622 7.88239 38.3085 -7.50107 -2.24579 -520 1 1.15265 1.71178 2.84381 -8.4531 -11.9611 -9.59212 -521 2 1.05399 2.26522 2.05124 -0.803687 -1.8039 9.5303 -522 2 1.83355 2.04817 3.41993 6.13064 16.5152 3.77918 -523 1 4.1533 15.0772 10.0179 -3.20174 -0.437736 -9.29092 -524 2 3.98656 15.1016 9.06421 1.0299 1.2944 4.52592 -525 2 5.05261 14.7702 10.1253 7.00528 -3.42074 -2.93025 -526 1 7.40026 2.22746 14.7687 6.49168 5.19513 -3.0061 -527 2 7.05161 1.63346 14.1063 -3.12724 -4.90201 -3.09738 -528 2 7.91685 2.87588 14.258 -12.5256 -3.95349 11.2802 -529 1 18.373 14.546 2.1576 32.8202 -8.56769 3.71586 -530 2 0.641523 14.7991 2.40659 -13.3331 -4.12423 -2.43111 -531 2 17.8688 15.3457 2.17573 -14.9783 16.0191 -2.18472 -532 1 10.0269 2.72027 12.9069 6.62939 -13.0178 -15.3878 -533 2 10.0552 2.15154 12.1041 -3.85604 9.52515 15.5624 -534 2 9.22213 3.24102 12.837 -1.7712 4.41938 -1.42751 -535 1 2.97754 8.87028 12.9985 -9.05038 -0.677068 -3.47801 -536 2 3.45417 9.69118 12.8049 -4.31376 -0.734034 1.18179 -537 2 3.62806 8.2766 13.3769 7.01874 -2.97808 -1.19575 -538 1 3.19567 8.6035 3.77658 -19.8399 -15.185 62.8422 -539 2 3.69787 9.2024 3.27039 20.7823 26.7884 -21.1607 -540 2 3.25417 8.93577 4.73429 1.71088 -18.6185 -45.3432 -541 1 5.68333 7.2353 8.59567 4.24349 7.94903 8.11652 -542 2 5.64033 6.27333 8.54735 -2.49289 0.630165 -0.0839225 -543 2 5.00997 7.53803 9.22801 3.10928 -6.89318 -6.51723 -544 1 14.901 1.57394 1.8387 15.5968 1.99798 -17.643 -545 2 15.036 2.2757 2.46438 -7.07983 8.8607 13.8203 -546 2 15.4483 1.85956 1.08282 -11.9705 -11.4344 6.74504 -547 1 8.60581 15.0641 0.724175 -1.0343 -0.581701 -1.65436 -548 2 9.36267 14.9264 1.3224 -11.0408 7.07619 -5.07103 -549 2 7.85377 14.5885 1.11097 4.42293 -0.805501 -0.698164 -550 1 15.4669 1.42093 7.20398 -6.02567 -16.758 -12.9624 -551 2 14.8047 0.91537 6.67859 11.4397 13.2212 12.6179 -552 2 15.1632 2.33261 7.23494 -7.42764 0.585266 4.6538 -553 1 4.96609 12.9239 18.4605 4.9692 1.49742 18.5571 -554 2 5.35493 12.9668 0.719228 -7.36506 -0.705061 -15.6984 -555 2 5.64055 13.3191 17.899 -0.422768 -0.432726 -0.922633 -556 1 15.3869 8.64959 18.0541 15.2167 5.00615 -15.1922 -557 2 15.9585 9.21901 17.4831 -18.3202 -12.4364 12.18 -558 2 15.1184 9.19177 0.153179 1.36579 6.92031 5.44875 -559 1 12.0051 3.11685 18.332 2.92261 2.37371 -0.430118 -560 2 12.2267 2.91556 0.611981 0.907964 -7.8545 -12.3252 -561 2 12.4512 2.48545 17.7302 -5.34745 5.71129 14.8863 -562 1 13.1901 12.7142 5.17454 1.37013 -5.58194 -4.10925 -563 2 13.4698 11.8626 4.7966 3.05379 7.74077 7.48289 -564 2 13.3871 12.6804 6.11832 -0.290674 -0.040691 0.190289 -565 1 6.14326 7.19304 0.194857 -1.9202 -41.4233 1.79985 -566 2 6.22321 8.10871 19.0299 -3.97355 27.3971 1.06104 -567 2 5.34431 6.86352 0.645447 4.46952 5.26437 -3.48858 -568 1 17.7307 15.8888 14.9367 -21.823 -0.594011 -1.7362 -569 2 16.7484 15.9241 14.9389 21.2696 3.13718 0.352088 -570 2 17.9521 15.7271 14.013 1.78287 0.501162 -2.11552 -571 1 13.1218 0.925759 16.6825 5.50042 -3.78674 2.95198 -572 2 14.072 0.793445 16.8378 -4.97223 1.91263 -2.37602 -573 2 12.7827 0.0340456 16.5234 -2.01103 3.41826 1.69274 -574 1 10.8951 14.5133 7.41586 13.7556 -0.655539 -10.0126 -575 2 10.113 14.0867 7.762 -7.55253 -2.39401 4.078 -576 2 11.587 13.8348 7.46973 -1.14 7.89944 2.21203 -577 1 17.6887 8.43188 2.14728 0.189858 20.0466 16.1607 -578 2 16.8137 8.45099 2.54699 -1.17102 1.13639 1.13697 -579 2 17.5844 7.88298 1.39033 0.906265 -19.3865 -19.2668 -580 1 12.4753 7.78007 2.02858 4.8513 20.3782 0.840615 -581 2 12.1866 8.68618 1.79587 0.511972 -15.0552 5.00442 -582 2 12.026 7.17575 1.43189 -2.95773 1.13832 -8.42618 -583 1 12.0482 14.5597 10.5042 0.0757192 -7.5571 -35.1431 -584 2 12.4064 14.4181 9.58152 -17.4466 3.18024 31.1693 -585 2 11.0871 14.7065 10.4137 10.382 -0.64313 -2.04102 -586 1 6.77399 6.81718 15.4895 -2.25325 13.5751 22.5023 -587 2 7.66157 7.15195 15.2455 -13.2429 -8.30723 6.82645 -588 2 6.46823 7.3192 16.2828 11.602 -10.345 -19.2772 -589 1 7.96932 4.46689 13.3146 44.2968 21.2749 25.8476 -590 2 7.30275 4.56825 12.6635 -24.5307 9.83264 -18.6775 -591 2 8.36434 5.36687 13.4905 -14.8867 -29.3495 -5.61281 -592 1 13.3256 12.2141 14.3822 1.63527 0.767161 7.05401 -593 2 13.3071 11.2456 14.3976 -5.0343 3.13323 -4.4607 -594 2 13.6638 12.4664 13.5147 0.299935 -1.6824 -0.371902 -595 1 14.5332 9.57639 7.29372 1.70864 -17.4355 -8.36329 -596 2 15.3543 10.0193 7.49698 9.6305 7.8311 1.84335 -597 2 13.8455 10.0241 7.76467 -11.6358 9.67674 12.3645 -598 1 12.6873 16.8129 3.32056 7.83014 22.6359 -6.17069 -599 2 12.905 17.3242 4.12577 -3.6908 -4.91509 -14.526 -600 2 12.6713 17.4548 2.56832 -2.22777 -11.4506 21.1383 -601 1 1.00404 7.03926 17.3541 -3.3312 4.1638 -9.33324 -602 2 0.198847 6.6977 17.7452 -7.86562 1.94891 9.68399 -603 2 0.682364 7.69734 16.7196 12.0745 -4.24482 -2.37704 -604 1 12.9524 4.87174 15.7195 8.90342 0.650689 -3.85785 -605 2 13.7851 4.36673 15.5939 -16.3603 12.0475 7.07164 -606 2 13.1756 5.81397 15.8059 7.81047 -7.07308 -0.568692 -607 1 2.31363 3.41121 5.09984 1.34414 -8.27729 12.6429 -608 2 1.77118 2.94066 5.78541 14.4044 18.7697 -14.1923 -609 2 2.78995 4.15649 5.52715 -11.381 -10.4766 -6.15296 -610 1 8.18617 10.9369 13.7076 0.678078 1.53711 40.2692 -611 2 8.26353 10.8511 14.7174 0.0908521 -0.97824 -49.4206 -612 2 8.97116 10.5326 13.3071 -0.268246 2.83437 5.42064 -613 1 12.9797 1.57395 13.2253 -11.1668 13.2146 -3.30054 -614 2 13.4836 1.606 12.3812 -13.0456 2.80048 17.4401 -615 2 12.3844 2.37352 13.292 24.5144 -24.3843 -9.90982 -616 1 6.623 13.6575 2.08401 -19.1133 11.282 9.3836 -617 2 5.9939 13.9784 2.7781 14.9337 -6.87798 -17.2483 -618 2 7.26745 13.1178 2.55198 -2.04458 -0.845032 2.89429 -619 1 15.8406 6.42424 12.5401 -13.2713 -11.8586 11.2716 -620 2 16.4194 6.98592 12.0445 9.49352 10.2235 -13.5209 -621 2 16.1454 6.51524 13.4484 4.14662 -0.822673 1.52229 -622 1 16.7707 0.701968 9.54479 -0.33564 -15.5889 9.3319 -623 2 16.6398 18.4357 9.88026 3.64558 8.61996 -2.27841 -624 2 16.2643 0.755347 8.72872 -0.899564 4.78829 -7.90839 -625 1 6.16924 11.6733 8.25771 14.6298 -10.0406 -3.26225 -626 2 5.33846 11.3866 8.66461 9.26092 -3.17897 1.03444 -627 2 6.69681 10.8652 8.03849 -20.9756 15.4878 5.14008 -628 1 2.79271 8.6573 0.35403 -23.76 -9.02274 -22.2632 -629 2 2.25448 8.23641 18.2541 16.977 17.0562 34.1458 -630 2 2.21462 9.29512 0.821612 5.57875 -9.71134 -10.0126 -631 1 10.106 10.3292 6.60358 -3.61165 1.9136 -10.2284 -632 2 10.6792 9.71276 7.06962 0.244318 -4.43661 2.14915 -633 2 10.3272 10.2595 5.65755 0.987804 2.37269 11.054 -634 1 6.86896 15.7547 6.74185 -9.45188 0.350857 10.5778 -635 2 7.01957 16.2495 7.56813 1.20841 -3.75655 -8.95365 -636 2 6.86937 16.4078 6.03145 5.97827 -1.66506 -1.56051 -637 1 6.52554 12.9289 5.84178 -0.357514 -5.09084 -2.41361 -638 2 6.62829 13.798 6.2286 3.16894 9.75908 1.28602 -639 2 6.09212 12.3914 6.51525 3.69897 1.96572 0.733322 -640 1 16.7568 12.518 9.72465 -9.23185 -13.2632 0.47822 -641 2 16.902 11.7866 9.09243 0.130969 14.0381 8.74694 -642 2 17.3592 13.2171 9.48659 4.61146 3.47499 -3.98224 -643 1 6.24919 2.86496 2.77119 -11.0856 -12.869 -3.38869 -644 2 6.47325 3.75226 2.51474 6.07925 14.4727 -0.649249 -645 2 5.68088 2.55654 2.04869 4.52067 -4.17334 4.94091 -646 1 10.7277 3.04594 3.24275 -5.68944 3.06595 0.875255 -647 2 10.1765 3.79746 3.50451 2.82785 -3.23936 -2.03517 -648 2 10.278 2.63972 2.48897 0.815959 0.513447 0.723514 -ITEM: TIMESTEP -90 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.787 6.66827 17.9842 -16.1402 -3.16192 1.04025 -2 2 7.92621 6.66814 18.4555 15.1954 -0.455805 -12.5376 -3 2 8.71175 6.0436 17.2441 2.25338 3.19171 10.1252 -4 1 0.22099 8.38854 6.75163 1.7867 -5.58088 53.0968 -5 2 0.258391 8.22026 5.83332 5.30707 -13.3892 -38.1472 -6 2 0.61579 7.61263 7.23543 -10.6686 22.8516 -15.6901 -7 1 8.66795 0.370206 6.9239 18.6241 3.37743 -9.56875 -8 2 9.59619 0.315354 6.61478 -16.3273 1.21351 7.23111 -9 2 8.27983 1.03351 6.33448 -2.90229 -5.54848 4.92815 -10 1 6.43573 1.74596 11.7835 34.1799 -16.6044 -13.764 -11 2 5.93979 2.40996 12.1988 -27.1883 29.6469 18.8725 -12 2 5.80753 1.07598 11.5419 -8.40397 -16.9848 -5.34211 -13 1 6.95318 5.50156 2.37044 -56.4905 40.6357 15.9903 -14 2 6.31995 5.85318 3.09808 38.0444 -22.8427 -29.8317 -15 2 6.63738 6.03683 1.59693 20.7004 -19.4106 17.4304 -16 1 16.2563 10.1963 16.0713 -10.5934 -3.27458 3.94447 -17 2 16.9716 10.3961 15.4827 15.3322 4.9096 -4.70747 -18 2 15.8903 11.0434 16.3496 -2.84586 0.096923 -3.72852 -19 1 10.8156 14.9572 2.29652 -13.5477 -14.1276 -10.2117 -20 2 10.6343 14.4303 3.07787 2.79926 -3.05354 4.26547 -21 2 11.1766 15.7627 2.6355 11.3372 16.7492 6.7502 -22 1 17.2002 8.21443 10.9436 15.2126 5.40823 -8.20499 -23 2 16.6458 8.84622 11.4125 -4.33506 2.62691 -0.328418 -24 2 17.9515 8.74734 10.6145 -8.68143 -7.05886 2.54317 -25 1 14.6067 16.0259 16.3377 27.3765 -5.03456 2.51249 -26 2 13.6996 16.2768 16.4047 -22.3019 9.86517 -5.17321 -27 2 14.7963 15.6285 17.196 -1.96556 -8.36093 -2.03831 -28 1 12.1458 13.2907 0.563101 15.519 -14.4585 7.5186 -29 2 11.8598 13.3671 18.2945 -8.9445 7.51312 -6.12139 -30 2 11.6592 13.8773 1.15113 -3.3891 6.78651 -5.827 -31 1 9.32161 5.49231 3.86239 -40.7454 -0.097831 27.7 -32 2 8.82419 5.45502 4.73277 24.2157 -2.28744 -25.4595 -33 2 8.56838 5.45751 3.23664 18.1191 1.43276 -0.568008 -34 1 1.5546 3.92475 11.5547 -2.15894 45.2634 -4.40984 -35 2 1.55046 4.88574 11.8201 -3.55694 -26.3933 -6.97822 -36 2 1.92957 3.45678 12.2837 10.4321 -13.9157 16.7147 -37 1 2.10319 6.96614 8.15085 -9.44208 -8.37285 -17.308 -38 2 2.4095 7.43328 8.92365 8.57391 0.445975 10.2393 -39 2 2.10294 6.01871 8.3456 1.70875 2.69997 7.84786 -40 1 5.23855 4.482 7.82422 -14.5525 -1.69806 -15.7353 -41 2 5.37847 3.52895 7.72628 3.24739 1.15002 6.52498 -42 2 4.55634 4.7134 7.1559 12.5144 1.33119 10.811 -43 1 3.38552 2.88255 17.3879 -7.38377 33.0145 14.859 -44 2 4.08387 3.35622 16.9066 -6.09174 -4.5148 -0.339366 -45 2 2.81217 3.57956 17.8286 22.0641 -22.8641 -14.398 -46 1 7.5324 5.43864 6.19559 -6.90202 6.90038 35.1799 -47 2 8.08818 5.95892 6.84983 -22.5477 -17.4794 -25.4925 -48 2 6.78022 5.04202 6.71812 26.5249 9.35209 -13.645 -49 1 9.82024 7.03039 12.0775 19.8901 0.0780072 21.9724 -50 2 10.117 6.21395 11.6931 4.07542 -9.22938 -4.80372 -51 2 9.09589 7.30435 11.5485 -23.243 9.22364 -20.0663 -52 1 13.9806 3.7694 8.09667 -19.6388 4.31534 -31.7671 -53 2 13.3819 4.49155 7.81719 15.167 -9.87345 1.12215 -54 2 14.3046 4.00637 8.94223 9.52837 8.93591 30.7953 -55 1 4.52742 17.134 3.88467 -0.450754 13.2049 4.39156 -56 2 5.37483 17.5703 4.13521 -18.32 -2.84079 -10.9512 -57 2 3.94957 17.708 3.32475 23.4139 -10.9615 8.41036 -58 1 16.2726 16.5634 10.552 38.1711 -6.17539 -26.5181 -59 2 15.4837 16.6086 11.0514 -31.396 0.528555 16.213 -60 2 16.0986 15.9648 9.80419 -5.24542 6.81385 7.69127 -61 1 1.94125 4.78402 0.0638345 24.0582 25.3647 11.1071 -62 2 2.62474 5.1599 0.67023 -17.1428 -14.5257 -4.57865 -63 2 1.76164 5.54704 18.141 -7.28608 -7.40463 -3.41134 -64 1 11.2518 13.2771 16.4354 2.60185 -12.9515 -12.3757 -65 2 10.6918 12.4717 16.5304 19.7397 14.6013 -5.52798 -66 2 11.8919 13.1107 15.7025 -16.8897 -0.368153 14.685 -67 1 10.0575 10.919 16.7613 6.16873 -18.0385 3.66167 -68 2 10.4442 10.0133 16.8612 -13.1447 30.924 -0.515142 -69 2 9.09987 10.8482 16.7186 0.711039 -4.16381 0.34444 -70 1 11.8614 17.5086 13.5019 6.48767 -7.71286 -13.5562 -71 2 12.4999 17.0938 12.8959 -9.94411 -4.10313 8.27478 -72 2 12.0757 18.4326 13.4127 -0.0140719 16.2542 2.74368 -73 1 6.39981 9.50139 12.337 -4.6648 -8.8035 -19.3883 -74 2 6.97362 9.2422 11.6012 -0.80266 1.15987 5.77958 -75 2 6.9622 9.95325 12.9581 6.38846 6.66359 6.95977 -76 1 16.2975 12.8974 2.78222 -12.345 -27.8929 4.9875 -77 2 17.1496 13.2141 2.51749 15.349 9.48057 -2.38836 -78 2 15.7502 13.672 2.87844 -10.3717 9.81447 0.854078 -79 1 0.774 12.7819 5.86324 -32.223 -2.64552 -12.7856 -80 2 1.10971 12.9185 4.95432 -4.25214 -7.81578 11.8108 -81 2 18.4306 12.6074 5.76822 36.341 8.50215 1.05579 -82 1 5.29891 16.3721 18.4261 6.47 -16.9938 9.7884 -83 2 5.51669 15.4746 18.1046 -4.53971 18.6444 -2.10572 -84 2 5.85038 16.4657 0.570301 -5.83847 6.29943 -2.02707 -85 1 0.695227 7.70772 4.16735 36.5725 18.4792 -22.7587 -86 2 0.10368 7.96447 3.43723 6.76909 -3.37176 10.733 -87 2 1.60166 8.10351 3.91123 -45.3891 -20.8895 14.9183 -88 1 3.19365 9.10151 6.50287 -37.0597 -13.4257 3.63648 -89 2 3.6513 8.68447 7.23829 0.216969 0.250287 -1.31356 -90 2 2.24726 8.75126 6.54108 37.1121 17.8096 0.286984 -91 1 7.35199 10.4473 16.1779 -19.0362 -10.3824 27.97 -92 2 6.56517 10.9544 15.9216 9.49501 -5.7134 5.26362 -93 2 7.13832 10.0279 17.0488 0.309364 15.3336 -19.7914 -94 1 11.0163 0.890853 5.00632 -3.98909 -12.3472 3.8442 -95 2 10.8807 1.76939 4.61668 6.53092 -8.55309 -4.92776 -96 2 10.738 0.225438 4.34173 2.35985 18.608 2.04389 -97 1 4.21667 2.95093 13.149 10.2014 -19.1015 31.4776 -98 2 4.53515 3.41914 13.9504 -8.71013 -4.86526 -13.316 -99 2 4.15898 1.99936 13.4513 -0.534052 25.4454 -15.6313 -100 1 8.50322 10.2612 1.79208 -4.34668 -17.3092 21.2914 -101 2 8.27549 10.8526 2.5321 5.30441 -1.44182 -6.44774 -102 2 8.58493 9.36982 2.21324 2.85947 21.4101 -9.02924 -103 1 10.3161 1.69184 15.4745 -6.1912 0.342966 -7.58309 -104 2 11.1781 1.38278 15.7166 17.9205 -0.758309 5.87707 -105 2 10.347 1.84648 14.5196 -5.50104 2.18071 3.0962 -106 1 2.60936 12.9662 7.92592 -2.1007 2.96569 -8.82009 -107 2 3.10883 13.7131 7.55922 1.74385 -4.33572 0.675454 -108 2 1.96491 12.7329 7.23617 6.25685 -1.04193 4.90183 -109 1 3.83706 11.6816 4.96058 -22.5573 -14.4893 8.95363 -110 2 3.56827 11.1846 5.76493 10.0033 8.11351 -16.9036 -111 2 3.08816 11.5736 4.33469 10.7007 11.5305 11.906 -112 1 6.6582 14.5337 16.9912 3.19916 -10.5164 -7.18554 -113 2 7.36558 15.1576 17.1605 2.12516 -0.469731 1.77687 -114 2 6.47854 14.5937 16.0445 -2.82585 4.49818 1.60201 -115 1 14.2037 14.4903 3.21857 16.956 -7.57282 -16.8086 -116 2 13.9492 15.374 3.44691 -9.21692 15.261 -0.929302 -117 2 13.8764 13.9351 3.91269 -8.69982 -10.6193 13.7942 -118 1 8.69855 18.0357 16.1264 41.5507 -6.08144 10.5978 -119 2 9.33855 17.4056 16.5195 -30.3672 -5.67283 -6.86348 -120 2 9.34419 0.0405339 15.8183 -19.2067 16.0047 -5.03817 -121 1 4.69307 1.79842 4.89677 16.2385 30.5389 -26.6001 -122 2 3.80396 2.19318 4.80489 14.8244 -2.46841 6.40587 -123 2 5.29999 2.32882 4.27745 -28.5893 -25.5208 24.7929 -124 1 15.0277 12.5795 16.5521 32.6678 1.07726 26.51 -125 2 14.723 12.7481 17.4682 -6.07814 3.10734 -21.8061 -126 2 14.3421 12.5499 15.8992 -22.7964 0.862239 -7.92322 -127 1 15.7044 18.5089 16.8468 26.9219 -3.0014 45.6431 -128 2 16.268 18.6119 17.6883 -20.0241 -2.05323 -42.0683 -129 2 15.5234 17.5608 16.7959 -6.5303 3.1055 -1.70461 -130 1 1.37672 1.34924 16.652 -10.0314 2.12664 3.94932 -131 2 2.13238 1.94076 16.8287 -14.5592 -12.7899 -0.0819953 -132 2 0.657997 1.59844 17.2733 17.8805 -0.89879 -9.33461 -133 1 18.2331 4.34642 15.9005 -0.884234 -3.04582 -21.1642 -134 2 17.8346 3.73179 15.2509 9.01129 10.3034 11.7071 -135 2 0.449037 4.61451 15.5361 -9.49368 -5.77709 6.1071 -136 1 12.1007 17.0847 16.1341 -21.8736 -13.8645 50.4236 -137 2 11.3773 16.6353 16.6829 29.7152 15.2039 -30.2146 -138 2 11.8045 17.1565 15.2358 -4.92233 -3.24187 -16.5992 -139 1 16.1203 2.66556 18.245 -33.6191 11.8512 -24.8852 -140 2 15.5683 3.39571 18.6154 19.5646 -10.4389 -9.45588 -141 2 15.8602 2.60471 17.2935 4.4965 0.524143 22.3318 -142 1 6.68711 13.7575 10.0686 6.57394 0.780895 15.4701 -143 2 6.65896 13.3749 10.963 -3.37269 2.77311 -6.77332 -144 2 6.71723 13.0193 9.46247 -3.0919 -8.05072 -6.49535 -145 1 10.1832 18.4638 2.68288 15.4984 11.1175 -14.1442 -146 2 10.4797 0.410785 1.94548 -7.56539 -13.8801 19.3089 -147 2 9.29042 18.2071 2.48382 -12.5464 -2.66261 -5.58966 -148 1 3.06565 17.654 6.19973 -11.4817 2.82915 -15.5316 -149 2 2.17867 17.6912 5.79869 7.15707 -3.68965 15.0105 -150 2 3.60434 17.7569 5.40979 11.429 -4.57556 5.13078 -151 1 12.6359 16.7831 7.87678 -34.4323 5.42099 5.88286 -152 2 11.8215 16.2589 7.70694 19.4452 0.972157 -0.554869 -153 2 12.3283 17.4377 8.53506 12.9634 -4.48143 -6.06952 -154 1 14.8812 15.2555 8.26349 -9.13488 6.23831 13.721 -155 2 14.2179 15.9485 8.09528 6.25869 -7.42326 0.874894 -156 2 15.4123 15.1764 7.46942 0.572987 8.13089 -2.89012 -157 1 17.8363 18.2748 0.235726 -36.9104 2.14965 -2.72595 -158 2 18.5544 17.6878 0.132306 25.4932 -25.6882 -8.95291 -159 2 18.2375 0.371142 0.648791 5.78715 27.9621 12.2792 -160 1 0.76648 10.5228 1.42349 -23.6052 -44.6853 36.9297 -161 2 -0.0625164 10.0248 1.72181 36.7073 15.4552 -13.6362 -162 2 0.483164 11.1861 0.82966 -10.4498 25.872 -24.2739 -163 1 1.81496 12.3027 3.28068 4.06427 7.40541 18.1542 -164 2 1.38036 11.6556 2.74613 -8.62838 -16.0879 -14.4133 -165 2 2.12935 12.9782 2.6808 0.203437 6.54347 -1.70293 -166 1 0.715096 17.2857 4.99328 6.02973 16.9927 -22.851 -167 2 -0.0549074 17.8034 5.17132 -8.63108 24.1627 -3.07112 -168 2 0.561936 16.5317 5.51148 1.70853 -39.3498 23.4345 -169 1 1.0126 0.815092 9.34853 9.77893 1.05612 10.9097 -170 2 1.24172 0.537916 10.2451 4.93082 3.28815 4.21298 -171 2 0.133534 0.483606 9.24599 -18.3012 -2.93221 -7.23643 -172 1 16.7899 2.36695 13.4143 1.34336 11.0529 -24.546 -173 2 16.9036 2.71504 12.491 -0.235106 -7.90147 26.8103 -174 2 16.4417 1.47344 13.309 3.25474 -1.82726 5.59598 -175 1 2.66167 16.0077 12.0598 12.6303 -22.6944 6.71055 -176 2 3.01062 15.6298 12.8947 -8.01809 9.38789 -15.4913 -177 2 3.11281 15.5097 11.3415 -7.7677 12.8204 10.8964 -178 1 16.364 15.512 6.14932 19.0855 9.58845 -19.9598 -179 2 17.3177 15.4404 6.40388 -23.0707 9.20906 -7.80583 -180 2 16.2465 16.2844 5.52559 8.28806 -24.9431 19.8586 -181 1 5.77951 5.20043 11.8033 8.47507 -20.9263 -15.707 -182 2 5.6405 6.00993 12.2754 -6.27864 14.793 10.9641 -183 2 5.18835 4.5564 12.2066 -2.11002 -1.11499 -2.91817 -184 1 15.1794 4.92089 0.775894 -18.0102 -8.76269 31.4284 -185 2 14.9497 4.67568 1.72392 8.26683 8.97624 -32.6089 -186 2 14.3636 5.23769 0.366515 4.70525 -0.664057 3.69432 -187 1 16.3975 16.4382 1.83859 15.8969 -1.83249 -31.9545 -188 2 16.3175 16.7184 2.73629 -8.02889 11.6848 21.5541 -189 2 16.8259 17.1655 1.34034 -8.03244 -7.80667 10.4102 -190 1 0.153841 4.83744 3.963 18.3567 41.8245 -8.83163 -191 2 0.481764 5.78512 3.86014 -17.0028 -34.1388 7.97498 -192 2 0.952119 4.32423 4.11352 -0.77715 -2.59924 4.82879 -193 1 2.94647 15.0748 15.1079 -17.5423 -9.74792 39.2804 -194 2 2.84668 14.6538 16.0052 7.88621 4.55617 -28.9019 -195 2 2.37581 15.8415 15.2342 5.36547 9.02165 -11.4736 -196 1 1.04118 14.6398 9.41517 21.0794 -20.4815 -17.0137 -197 2 1.63478 13.9208 9.06194 -19.3512 25.5288 8.96267 -198 2 0.7851 14.3144 10.2695 -7.28135 -4.68142 11.1743 -199 1 13.5343 16.512 11.5541 0.415781 17.9887 -13.1724 -200 2 13.2087 17.3014 11.0493 5.42519 -19.6136 10.4452 -201 2 13.1525 15.7431 11.1062 -5.37134 4.1326 5.42785 -202 1 4.79073 1.57335 0.678685 -10.2425 -16.6589 -0.602312 -203 2 4.2243 2.02466 0.0269211 5.06007 -3.50169 9.95598 -204 2 4.26355 0.829094 1.04695 5.40097 16.8315 -2.73739 -205 1 1.55169 18.6011 11.9401 -14.2618 14.3088 -13.4455 -206 2 1.54559 0.423493 12.7773 -0.760074 5.21042 2.72529 -207 2 2.10509 17.8447 12.0596 11.7149 -17.0814 4.30068 -208 1 11.3926 10.0859 4.15406 35.1149 20.4659 -18.5884 -209 2 11.4922 10.6036 3.30306 -8.07316 -21.3073 26.3838 -210 2 12.3257 9.94393 4.45754 -25.8381 1.71308 -8.95455 -211 1 8.18732 12.2257 3.75704 -12.727 -0.351394 27.2441 -212 2 9.08394 12.5468 4.00553 -19.5779 -3.96369 2.83586 -213 2 7.55786 12.2705 4.55735 35.1927 2.13842 -31.3906 -214 1 14.6183 4.0143 3.36201 13.432 11.2186 16.7224 -215 2 15.2472 4.27703 4.07585 -12.4329 -9.47893 -15.9273 -216 2 13.7521 4.30159 3.67007 -0.91716 0.860244 -2.07153 -217 1 5.73358 1.67843 7.60794 -24.3615 -22.8066 38.6551 -218 2 5.03202 1.06037 7.9982 26.7251 29.011 -15.8684 -219 2 5.4689 1.83957 6.71483 -6.40801 -4.86943 -26.9957 -220 1 17.8709 0.966847 4.84319 9.19834 18.9135 -13.8104 -221 2 18.365 1.30942 4.06688 -7.16187 -11.4028 13.2983 -222 2 17.8528 1.72071 5.45189 -4.56365 -9.98849 0.137087 -223 1 6.8232 9.21412 4.53503 0.0591715 -6.07859 -16.7729 -224 2 6.61803 9.33533 5.45725 2.71524 4.28405 13.1117 -225 2 7.76963 9.02928 4.48077 0.0640272 -1.66157 1.55662 -226 1 2.43776 14.707 2.05519 12.3789 -12.7502 -17.0618 -227 2 3.26162 14.6424 2.56361 -5.44595 2.48516 -0.426941 -228 2 2.66563 14.4192 1.14611 -3.66427 9.22898 15.3942 -229 1 17.2291 12.9271 13.0675 -25.7945 34.5425 2.40746 -230 2 16.3582 13.328 13.3279 21.6203 -16.0155 -5.62376 -231 2 17.7378 13.7209 12.8173 -0.837652 -12.191 -0.563337 -232 1 14.8245 10.5613 1.47762 -19.5687 -28.1113 -12.7998 -233 2 15.3117 11.2776 1.82539 19.2978 30.1093 14.6064 -234 2 13.9052 10.723 1.70642 0.475408 2.13461 -1.67485 -235 1 5.64982 6.63563 4.55084 7.38671 -15.2963 15.0755 -236 2 5.89214 7.54949 4.44479 2.16454 16.7651 -4.4857 -237 2 6.3044 6.30345 5.19757 -6.24708 1.07556 -9.93912 -238 1 8.10845 8.3271 10.3627 -2.57156 5.78827 13.3728 -239 2 8.61892 8.85799 9.7482 5.06505 3.86155 0.738683 -240 2 7.30116 8.09886 9.91192 -6.7312 -10.1116 -10.9746 -241 1 13.4488 18.4608 5.65963 -13.3307 -19.6223 8.99938 -242 2 12.6096 0.239632 5.39678 7.81848 3.10411 6.37483 -243 2 13.1935 17.7385 6.2846 5.11891 19.4349 -8.45882 -244 1 -0.00278136 2.5625 0.408955 -12.183 35.1922 -19.112 -245 2 17.7147 2.60224 18.7259 18.9642 -9.11891 12.7486 -246 2 0.290302 3.48872 0.227759 6.22068 -26.2608 7.60118 -247 1 12.9842 10.8497 9.70117 -72.6257 27.1129 -13.2266 -248 2 11.97 10.965 9.69449 48.4921 6.31007 0.109369 -249 2 13.0048 9.91956 9.83068 16.3628 -25.292 6.36111 -250 1 0.548273 12.2593 11.2103 29.2233 3.63314 -8.31727 -251 2 18.2651 12.1894 11.4198 -11.8267 3.42799 7.99272 -252 2 1.06577 12.5175 11.9926 -12.6507 -2.71608 -2.06856 -253 1 5.24515 7.35168 13.3154 -11.9716 -5.94003 -7.6844 -254 2 5.73604 8.07931 12.9223 2.64227 5.43904 4.60776 -255 2 5.63818 7.16239 14.1672 7.7875 0.124539 4.29694 -256 1 1.16856 6.76355 12.0035 -37.5881 -40.6251 -19.8542 -257 2 0.334741 7.08942 11.6206 8.86965 -4.87383 5.4559 -258 2 1.63397 7.52151 12.2381 28.649 45.7996 14.9133 -259 1 15.5501 9.75639 12.3967 -1.92883 21.1886 15.8166 -260 2 15.1116 10.6344 12.221 21.3449 -31.3991 6.12972 -261 2 16.0605 9.85526 13.2245 -13.7753 0.465455 -14.4819 -262 1 16.5858 12.6354 5.59083 -2.62715 14.8355 -19.0185 -263 2 16.4437 13.5882 5.83081 0.436603 -22.1434 -16.2318 -264 2 16.416 12.5171 4.60718 5.48378 12.0784 33.3147 -265 1 6.40279 9.86277 0.0794915 -20.3924 -8.41649 -9.56759 -266 2 5.55524 10.218 0.380594 4.23452 2.32222 -1.66862 -267 2 7.0555 10.2042 0.674211 16.128 4.48978 14.4774 -268 1 12.2427 6.01171 4.00399 -23.1281 -36.6346 24.2315 -269 2 12.2798 6.64894 3.31747 0.117026 23.2517 -16.0656 -270 2 11.2984 5.74139 4.08171 19.6095 7.84283 -4.73597 -271 1 0.360057 12.9056 0.031807 -8.11921 2.1908 5.08387 -272 2 18.8977 13.4796 0.805411 -3.72305 -1.59029 -3.55744 -273 2 18.3786 13.2516 18.0169 7.85083 -4.92073 3.80969 -274 1 3.55677 18.7152 8.66247 19.9063 -6.335 -5.44295 -275 2 3.49677 18.1902 7.8473 -5.97778 6.84736 4.02201 -276 2 2.66917 0.348355 8.87781 -8.06089 0.921211 -3.36616 -277 1 7.26214 17.4262 4.43744 19.2672 26.0801 -3.30237 -278 2 7.75433 18.2474 4.74147 -22.4281 -27.0983 -14.818 -279 2 7.37471 17.3728 3.46226 -1.25032 2.03681 18.5343 -280 1 9.25258 17.1703 12.1759 28.8617 -14.1678 9.07352 -281 2 9.26958 16.3393 11.6513 -2.57153 16.4076 7.11435 -282 2 10.1283 17.1978 12.6604 -29.6357 0.448077 -14.593 -283 1 13.2677 13.193 7.99719 -21.1722 -32.5843 10.0566 -284 2 13.3388 12.6042 8.77917 0.104276 5.764 -17.169 -285 2 13.8077 13.9427 8.17139 23.4211 18.1414 5.93605 -286 1 14.7593 2.91325 15.4943 24.3728 -2.49696 -23.5999 -287 2 14.0361 2.3713 15.1546 2.238 -3.60609 4.01929 -288 2 15.4274 2.94021 14.7667 -15.6113 -2.56038 15.0831 -289 1 9.9738 15.6484 16.9671 -8.54083 0.59912 -5.05632 -290 2 10.1057 14.7848 16.5569 10.1368 1.85589 1.18764 -291 2 9.46144 15.457 17.7506 -1.80616 -1.66933 10.9911 -292 1 11.2344 8.55758 16.6355 7.77426 1.92795 -6.45244 -293 2 10.4646 8.11257 16.295 -8.96701 -9.58703 -5.10609 -294 2 11.6991 7.91388 17.1598 3.61158 -8.68538 8.99751 -295 1 4.14955 18.3179 16.8036 -6.71252 9.00681 -6.36217 -296 2 4.47312 17.6803 17.4466 6.33314 0.74429 2.85153 -297 2 4.24503 0.569095 17.1648 -0.42517 -11.8307 0.148866 -298 1 2.33957 4.29184 8.91302 22.2448 -7.34702 27.8454 -299 2 3.30686 4.08394 8.81247 -29.123 7.66299 4.05924 -300 2 2.12598 4.16624 9.8839 8.54186 0.354435 -34.7065 -301 1 9.95255 10.4179 9.8571 -18.8164 27.0404 -12.2944 -302 2 9.4534 11.1894 9.4744 17.3372 -21.5482 9.10503 -303 2 9.8309 10.4683 10.8129 6.92766 -2.76642 -0.156957 -304 1 9.80127 0.922938 10.8108 4.3272 3.59983 6.04006 -305 2 9.35046 0.175669 11.2139 0.840012 -6.18623 1.13214 -306 2 9.1369 1.38463 10.2905 0.460774 -0.831922 -5.90435 -307 1 9.16459 15.1765 10.2101 -26.8722 -7.06493 -21.2153 -308 2 8.97785 15.8968 9.57551 3.0406 -6.31351 13.2231 -309 2 8.39419 14.5643 10.0571 23.5779 16.7742 11.4525 -310 1 0.773683 9.7544 10.1833 18.261 11.1305 -23.2394 -311 2 0.868202 10.7262 10.3345 -3.82315 -24.612 -0.100636 -312 2 1.30536 9.53677 9.37727 -17.4146 8.84667 24.1623 -313 1 17.2096 4.87642 8.04469 -12.9959 -9.21067 35.1395 -314 2 16.3347 5.16277 8.3943 19.7751 -0.094318 -9.55648 -315 2 17.6197 4.3572 8.78272 -10.3132 11.9302 -24.4143 -316 1 14.8095 14.6496 0.0373288 -5.69372 -9.04424 21.9283 -317 2 15.5101 14.9524 0.640087 -10.906 0.748239 -2.66247 -318 2 14.0769 14.3265 0.613297 14.425 8.36295 -12.6903 -319 1 3.89537 11.0996 9.55593 -9.82967 16.3938 -0.398364 -320 2 3.93242 11.2996 10.5001 -1.21387 -1.78602 1.5381 -321 2 3.39392 11.8407 9.15947 5.2768 -13.1919 0.569667 -322 1 11.4169 10.7371 1.49225 5.47317 24.4145 -6.81884 -323 2 11.5532 11.6314 1.08329 0.074839 -23.6179 10.2373 -324 2 10.4618 10.6109 1.50924 -1.9569 -1.96948 -2.8184 -325 1 13.1395 7.21524 12.5729 -20.455 -7.16835 0.858137 -326 2 14.0577 7.03675 12.4308 23.1896 -1.74136 0.0778831 -327 2 12.7378 6.3322 12.608 -1.47964 6.92135 2.9072 -328 1 9.65614 1.96645 0.86496 18.1931 4.09637 20.8777 -329 2 8.84682 1.67677 0.484793 -23.8326 -3.90796 -8.97572 -330 2 10.1746 2.31935 0.150168 8.91513 5.01659 -9.40528 -331 1 10.6386 13.4197 4.53193 2.28663 -4.65747 18.8344 -332 2 11.4948 12.9639 4.69275 -16.1918 12.7288 -0.469196 -333 2 10.3958 13.8423 5.38242 9.30576 -5.17735 -13.1714 -334 1 14.5273 1.57884 10.9459 15.1221 22.4117 -0.776229 -335 2 15.362 1.31139 10.5257 -10.7732 -5.17355 3.70166 -336 2 14.6474 2.54531 11.0746 -6.11584 -12.5888 -6.32845 -337 1 14.4766 12.0159 11.6273 -10.9263 4.56586 -44.1867 -338 2 15.2047 12.4077 11.0864 -12.0042 -9.95663 15.0185 -339 2 13.8634 11.5981 10.9451 22.3117 17.3775 30.6101 -340 1 8.16847 5.14124 9.81669 -29.5484 17.7318 23.7918 -341 2 7.27475 5.12719 10.2684 30.6512 -1.40914 -16.6308 -342 2 8.33799 4.26267 9.50012 -3.06916 -18.2431 -3.24008 -343 1 1.5108 16.9662 18.5044 9.55151 26.7901 -23.2493 -344 2 1.84435 17.2897 17.6363 -7.76754 -5.77411 19.656 -345 2 1.83481 16.0826 18.5596 5.96378 -22.3257 1.76596 -346 1 1.42717 17.3886 15.3379 47.0554 -13.0927 -7.45492 -347 2 1.50543 18.1882 15.8264 3.14075 27.3625 12.617 -348 2 0.523906 17.2066 15.2924 -49.7083 -12.5335 -2.74225 -349 1 3.49173 5.73723 6.04987 -5.63889 12.5308 6.32322 -350 2 3.05134 6.46754 6.5425 11.5005 -15.9447 -9.63575 -351 2 4.14223 6.14285 5.45548 -4.8412 1.1033 3.2125 -352 1 12.5916 9.51872 14.2408 10.4293 -27.0271 -12.8548 -353 2 13.028 8.79356 13.6831 -19.628 26.0366 30.4849 -354 2 12.3513 9.14884 15.1174 6.55215 0.813797 -17.5332 -355 1 4.09544 15.2089 7.12218 31.8609 13.6269 2.32941 -356 2 3.67616 16.0257 6.80924 -1.84113 -5.17266 1.34804 -357 2 5.07546 15.4284 7.13078 -32.8392 -10.6488 -3.17146 -358 1 0.799143 8.79431 15.1488 8.21516 12.8732 -16.9375 -359 2 0.575284 9.7423 15.0796 -2.5473 -12.0602 5.3867 -360 2 1.52676 8.70151 14.5038 -8.32138 -2.51513 8.31525 -361 1 12.8725 8.28632 10.0993 13.5644 -10.3417 -12.785 -362 2 13.6812 7.81606 9.78663 -13.8637 7.80766 13.5238 -363 2 12.7502 8.10095 11.0322 6.24745 -8.27276 5.3213 -364 1 15.2423 7.98405 3.44353 15.6799 19.5655 -11.9659 -365 2 14.4463 7.83544 2.89643 5.54982 -16.2362 17.4101 -366 2 15.5184 7.39607 4.17406 -22.72 2.15229 -11.0841 -367 1 17.1687 6.76019 0.0376092 -10.314 6.5713 -12.413 -368 2 16.7239 5.93548 0.292072 -0.0664332 9.88195 -1.29815 -369 2 16.4741 7.34647 18.2846 16.8516 -16.4801 16.1304 -370 1 8.96925 6.98328 7.86383 -27.8745 -15.8066 22.0328 -371 2 9.86939 7.24269 7.81058 30.3142 9.1639 -3.03437 -372 2 8.87474 6.48936 8.713 -1.39219 10.6855 -19.1169 -373 1 12.482 0.614891 1.23015 1.92335 -8.70167 1.10105 -374 2 13.2432 1.03802 1.64803 2.06157 -2.24376 -3.30204 -375 2 12.803 0.16068 0.442821 -0.913907 6.47573 3.0001 -376 1 5.66871 15.0647 14.4598 7.14191 19.2454 -5.51099 -377 2 4.75956 15.0903 14.7907 1.11348 4.01334 -3.77227 -378 2 5.94804 16.0038 14.294 -6.0872 -24.4911 3.70117 -379 1 3.73529 6.48244 1.70347 -4.32476 7.10488 -19.4811 -380 2 3.3805 7.26573 1.22404 3.0021 -10.505 14.7125 -381 2 3.73285 6.71028 2.6365 -0.71904 4.06656 1.73817 -382 1 3.86925 11.322 12.3296 2.55777 5.65869 0.326193 -383 2 4.7048 11.7602 12.5386 0.0734552 -4.93202 -1.70743 -384 2 3.20028 11.8652 12.7549 -2.96009 3.18005 0.676376 -385 1 5.3196 3.88545 15.7107 -12.565 72.4648 14.1271 -386 2 6.00107 3.31 15.4478 35.5939 -28.3589 -8.92722 -387 2 5.74724 4.80358 15.8116 -17.6513 -43.1362 -7.7855 -388 1 14.0258 10.1309 4.70784 36.378 -19.982 -23.5474 -389 2 14.2654 9.87929 5.60631 -3.02994 -1.07275 0.485782 -390 2 14.6765 9.60938 4.12831 -34.5421 20.7478 23.7761 -391 1 7.50853 17.298 8.98976 4.28677 22.6193 13.4416 -392 2 7.01472 17.6504 9.76182 0.935323 -12.9311 -15.6818 -393 2 7.87431 18.0869 8.55212 -1.49272 -9.54271 -2.09709 -394 1 4.57424 14.4015 3.77738 -1.32578 6.84514 50.6918 -395 2 4.51443 15.3073 4.2079 4.46262 -31.6709 -20.6737 -396 2 4.58351 13.7394 4.53798 -1.39317 23.0513 -31.5206 -397 1 14.2431 7.32994 15.8885 26.8814 9.55229 5.02737 -398 2 15.048 7.31796 15.3145 -19.1816 0.583054 17.9404 -399 2 14.5184 7.8184 16.7026 -8.00009 -12.2304 -19.9762 -400 1 3.00564 18.4171 1.98737 1.19435 35.3283 33.2576 -401 2 2.60973 17.9491 1.28647 -18.7059 -24.7202 -27.1582 -402 2 2.28625 0.311703 2.39571 15.2164 -11.2621 -13.5372 -403 1 7.97098 1.60459 4.54116 29.2267 3.13781 -13.0843 -404 2 7.39603 1.96083 3.86318 -8.15365 2.40339 -0.697123 -405 2 8.86388 1.74438 4.1564 -17.9094 -5.03071 12.9608 -406 1 2.50155 14.1648 17.7228 -14.4362 -20.2086 14.4505 -407 2 1.80023 13.5192 18.0233 22.5798 22.6486 -13.5864 -408 2 3.34474 13.7188 17.8802 2.38023 -0.79805 1.89101 -409 1 0.962462 1.97628 13.8796 24.0866 5.42438 -18.2963 -410 2 1.23331 1.73159 14.7528 2.00372 -3.67266 20.967 -411 2 0.0219615 1.96156 13.879 -26.3344 -0.788872 -2.58417 -412 1 4.34962 0.156713 13.8729 25.4477 -1.51409 -1.97896 -413 2 5.30295 18.5478 13.9084 -21.2168 3.6137 -4.76321 -414 2 3.99528 18.4902 14.7051 -3.29088 -0.042535 8.53213 -415 1 7.35889 1.01117 18.4602 -20.0845 2.29217 31.534 -416 2 7.53777 0.614221 17.6282 1.02155 -13.8743 -28.1328 -417 2 6.39885 0.929085 18.6632 17.4429 7.83311 -8.37388 -418 1 15.8463 18.3909 13.9448 -43.3072 10.6601 -1.92517 -419 2 14.916 18.6906 13.7723 29.0574 -10.6436 -1.66619 -420 2 15.8257 -0.445507 14.8871 10.2412 6.45473 0.424587 -421 1 10.2808 4.63783 16.2194 -42.4572 -26.934 -19.6441 -422 2 11.2059 4.65809 16.3645 33.0638 0.71496 4.62375 -423 2 10.0964 3.70704 15.9214 4.59595 26.5122 11.6188 -424 1 15.903 17.6519 4.47823 -22.6026 32.3058 18.5214 -425 2 16.5145 18.4189 4.46111 -7.58873 -12.9749 2.84853 -426 2 15.0701 18.0221 4.91498 30.26 -18.095 -22.6862 -427 1 6.91987 17.5654 13.9309 41.5981 2.12242 13.325 -428 2 7.49428 17.7119 14.7497 -22.2257 -6.74767 -31.4029 -429 2 7.56851 17.4237 13.1898 -17.2813 4.26485 21.283 -430 1 13.2143 6.40362 6.52296 -17.8609 -7.45559 2.6451 -431 2 14.0836 6.75111 6.37132 17.2928 3.48546 -1.85822 -432 2 12.8363 6.25317 5.64277 2.90235 4.29902 5.97585 -433 1 7.86013 2.26394 9.49062 -8.36252 -9.46169 -35.4407 -434 2 7.29684 2.1706 10.2513 -11.7917 -0.851936 13.7299 -435 2 7.34714 1.87564 8.72892 15.7155 15.0955 20.8405 -436 1 15.1343 14.8378 13.7575 -15.8142 13.0315 4.83039 -437 2 14.8532 15.0481 14.6708 3.35379 -3.45087 -12.098 -438 2 14.5629 15.3828 13.1802 11.493 -9.40285 7.27009 -439 1 9.38118 8.39884 3.83519 4.0123 -7.74443 -2.87465 -440 2 10.2467 8.83344 3.97294 -13.6344 -10.1795 -2.34121 -441 2 9.51993 7.43201 3.84247 0.270426 14.3255 0.324032 -442 1 17.6982 13.5806 16.4882 -11.1823 29.4115 -15.1875 -443 2 16.7477 13.4163 16.452 -1.16521 -4.14372 2.83933 -444 2 17.7994 14.4458 16.0124 3.95943 -25.1425 10.6502 -445 1 4.93057 10.3937 2.82949 21.3493 0.31084 -7.87351 -446 2 5.82872 10.0425 3.0149 -20.5327 4.11374 3.5741 -447 2 4.70497 10.9363 3.59521 3.63155 -1.89772 -0.291932 -448 1 3.65557 8.40975 9.92882 -7.92631 -13.4411 16.4299 -449 2 3.66668 9.34394 9.72247 1.00161 8.70404 1.26029 -450 2 3.36367 8.33438 10.8592 4.36465 5.8519 -13.4993 -451 1 15.9508 6.91708 5.85912 26.4071 -7.62551 -3.83966 -452 2 16.729 7.34279 6.26867 -14.5536 -3.6129 -4.6023 -453 2 16.2929 6.05819 5.53033 -12.7649 13.2481 9.54942 -454 1 15.2478 7.26488 8.9948 -11.5397 21.0457 -23.7706 -455 2 16.0349 7.57374 9.47019 -5.83 4.16597 -2.61919 -456 2 14.9977 7.92652 8.27445 16.2337 -23.38 28.7542 -457 1 6.17715 12.7863 12.74 7.06624 23.8889 14.8517 -458 2 6.98998 12.4152 13.1111 -3.934 -5.41615 -1.6338 -459 2 6.02064 13.6181 13.2483 1.6805 -16.267 -10.1818 -460 1 12.1255 4.53395 13.1266 36.5984 28.8141 18.352 -461 2 12.1988 4.68857 14.088 4.72218 -0.985297 -9.83354 -462 2 11.344 4.04995 13.0228 -42.0246 -23.4808 -8.79261 -463 1 11.4542 8.08345 7.86287 23.2187 -10.867 14.4494 -464 2 12.2022 7.55078 7.50013 -20.6002 10.1652 -0.104446 -465 2 11.6749 8.16233 8.821 -5.77941 1.62242 -23.2927 -466 1 16.9966 10.8 7.60022 14.0465 -17.3895 -10.8701 -467 2 17.6655 10.1188 7.31004 -18.6815 22.6831 6.1404 -468 2 16.8855 11.476 6.90625 3.56282 -12.242 0.823841 -469 1 5.28409 18.0615 10.7272 -25.4136 -4.73004 -4.09376 -470 2 4.85025 17.4105 11.3211 10.0924 14.2936 -14.0097 -471 2 4.61921 18.235 10.0106 18.3134 -6.11244 18.1083 -472 1 7.63344 17.4775 1.60819 -12.3126 -2.35291 35.094 -473 2 8.06049 16.702 1.26786 10.3266 -12.472 -14.3961 -474 2 7.64482 18.174 0.971148 2.96613 14.6858 -21.2308 -475 1 1.92556 12.9088 13.6099 -6.92879 6.84011 17.0322 -476 2 1.40166 12.3078 14.1747 6.51182 9.66465 -5.96466 -477 2 2.01688 13.7519 14.1152 3.80073 -20.221 -11.3532 -478 1 9.32296 6.74742 14.7603 -6.16505 19.9578 -6.21839 -479 2 9.80961 6.04203 15.1542 10.8193 -23.4577 14.2182 -480 2 9.81429 6.97553 13.9666 -4.58884 0.0213979 -5.59057 -481 1 15.2687 4.29028 10.7744 -16.6773 -11.1812 -9.87371 -482 2 16.185 4.03181 10.6852 9.89086 1.55812 4.86514 -483 2 15.2046 4.88146 11.5266 6.28069 5.56792 1.9642 -484 1 11.3833 6.23863 0.0689293 -3.19885 -6.29427 4.65322 -485 2 11.5449 5.27036 18.7473 -10.1654 17.1623 -6.02864 -486 2 10.4171 6.41156 18.6664 16.019 -11.974 -2.10863 -487 1 18.4779 11.4738 14.9298 -4.11302 6.12113 -30.5228 -488 2 18.0937 12.0014 14.1715 8.36132 -18.8326 26.0479 -489 2 18.3027 12.0103 15.7035 0.536699 7.83234 4.13522 -490 1 7.03799 9.27423 7.33397 -11.8444 -18.9096 15.35 -491 2 6.61404 8.50211 7.787 12.2323 17.6714 -16.3801 -492 2 7.97664 9.07639 7.31215 4.33333 -2.45816 -2.54611 -493 1 18.3885 15.3347 12.1965 11.3664 3.9942 -3.56245 -494 2 0.676524 15.5664 11.9851 -14.9026 2.39255 4.26485 -495 2 17.8062 15.8491 11.6143 4.55299 -1.04774 1.98359 -496 1 16.551 4.342 5.30396 -29.3567 -2.30965 40.8017 -497 2 16.5003 4.35995 6.30392 8.99046 -4.55546 -31.3189 -498 2 17.4312 4.58446 5.06774 26.2551 1.0485 -9.7407 -499 1 17.7614 3.18175 10.7726 14.454 -1.68376 5.55906 -500 2 18.6848 3.25815 11.0867 -17.2868 6.635 -4.74284 -501 2 17.731 2.30667 10.3896 -4.78084 -7.5669 -7.23363 -502 1 12.3288 18.6185 10.0887 4.81564 48.0444 9.66027 -503 2 11.5224 0.4701 10.402 18.5752 -22.9317 -12.6203 -504 2 13.04 0.683861 10.1001 -20.831 -28.6711 -0.571217 -505 1 10.4023 9.75891 12.5069 9.56908 10.7357 22.5843 -506 2 11.0968 9.84844 13.1991 -9.82495 1.00858 -15.0243 -507 2 10.3005 8.81694 12.4067 -0.389825 -11.0581 -5.16736 -508 1 0.728244 2.62509 7.20528 10.511 21.9286 8.67284 -509 2 1.10851 3.44304 7.59367 -9.47208 -14.047 -5.98037 -510 2 0.946108 1.9669 7.86838 0.119732 -6.07738 -1.41007 -511 1 0.301432 15.3195 6.88989 15.9737 -48.0831 -14.5816 -512 2 0.502768 15.5752 7.7858 2.08568 -2.79341 12.7124 -513 2 0.620951 14.3521 6.81024 -17.8336 49.2232 -1.9498 -514 1 17.0496 6.91172 14.9593 8.8057 -4.67917 1.70395 -515 2 17.812 7.50707 14.8676 -6.01141 -3.19386 0.836122 -516 2 17.3983 6.09137 15.355 -4.50622 8.29661 -2.9861 -517 1 9.11865 12.5108 8.02933 -49.9881 -7.42173 -16.2711 -518 2 9.47674 11.8107 7.47486 8.95817 -5.21768 -2.38673 -519 2 8.15231 12.5395 7.74329 38.6911 2.79466 15.4325 -520 1 1.1334 1.67756 2.81686 3.27117 15.7614 -6.58164 -521 2 0.957986 2.31477 2.10151 -6.66947 -14.3695 3.78127 -522 2 1.78538 2.12055 3.36586 -0.578909 1.22693 6.40118 -523 1 4.20106 15.0562 10.0364 -13.4085 1.18971 -5.18923 -524 2 3.93003 15.0868 9.10675 3.70212 3.27773 4.96515 -525 2 5.05647 14.6363 10.0432 10.3336 -3.36269 -1.32379 -526 1 7.40784 2.22679 14.822 -4.38879 4.63456 3.27925 -527 2 7.05629 1.62422 14.1639 1.19517 -1.6595 -3.72526 -528 2 7.83793 2.94849 14.3413 -6.72155 -4.85002 1.32971 -529 1 18.3301 14.5327 2.1542 24.8671 -25.4621 4.78212 -530 2 0.57397 14.7195 2.50861 -8.4973 4.51839 -6.64425 -531 2 17.8578 15.3422 2.05909 -12.5294 22.9533 -1.13776 -532 1 10.0489 2.71902 12.9028 6.85621 -14.8278 -12.6664 -533 2 9.96638 2.08865 12.1549 1.47254 10.1846 11.5218 -534 2 9.24995 3.25129 12.8895 -2.74325 3.95657 -0.856162 -535 1 2.95855 8.84401 12.9769 -19.5266 -12.9618 -2.46154 -536 2 3.45638 9.64099 12.8192 4.11354 12.8609 -3.4499 -537 2 3.6113 8.17746 13.175 10.7686 -6.78904 5.39462 -538 1 3.18595 8.60313 3.78164 6.49512 -8.67182 57.5105 -539 2 3.58728 9.20701 3.1814 16.1034 15.9636 -13.6327 -540 2 3.51933 8.8716 4.70776 -18.429 -13.2453 -44.8458 -541 1 5.73851 7.25721 8.5964 -4.13987 -1.96532 11.6754 -542 2 5.69005 6.29369 8.53393 1.30439 2.87011 -1.70973 -543 2 5.04632 7.51192 9.22575 1.66035 -1.11756 -5.95213 -544 1 14.9081 1.62503 1.83745 -8.73365 -28.3512 -14.8102 -545 2 15.1675 2.29904 2.4498 2.46531 19.8996 4.15138 -546 2 15.1848 1.81402 0.924567 6.2551 4.83326 15.3454 -547 1 8.63912 15.0489 0.67096 1.85438 -3.84451 5.87273 -548 2 9.43742 14.948 1.21756 -6.6173 4.03251 -1.68679 -549 2 7.96284 14.4978 1.10066 2.22069 5.93818 -4.9944 -550 1 15.4364 1.44293 7.19944 -29.9197 -3.33934 -17.0244 -551 2 14.7125 0.994492 6.68707 24.0317 7.87524 16.0302 -552 2 15.0797 2.33705 7.33252 4.46076 -6.95989 4.74521 -553 1 4.93029 12.8913 18.4644 10.9792 1.21933 18.1223 -554 2 5.27563 12.987 0.740174 -6.01723 -1.47567 -19.726 -555 2 5.68015 13.1369 17.9044 -5.07302 3.16897 2.74711 -556 1 15.3923 8.68146 18.054 15.694 19.9465 -16.5309 -557 2 15.9315 9.21769 17.4147 -18.0717 -17.5644 15.7946 -558 2 15.1857 9.29971 0.121687 -1.56315 -2.75746 2.59172 -559 1 11.9784 3.14039 18.3403 11.1408 -7.29272 18.8649 -560 2 12.1001 2.9975 0.653392 -4.70819 -0.503108 -12.7749 -561 2 12.4778 2.40933 17.9385 -7.35096 7.48199 -3.86664 -562 1 13.1896 12.7267 5.18606 4.81883 -3.59528 0.0329893 -563 2 13.4958 11.8346 4.97314 2.3467 3.28367 -0.068752 -564 2 13.4618 12.8881 6.09814 -4.13789 -2.12194 -0.520265 -565 1 6.18108 7.13483 0.245639 -8.98659 -24.3205 -5.24363 -566 2 6.15368 8.0627 19.0493 5.02048 26.2765 -0.395042 -567 2 5.28324 6.84248 0.444666 1.40419 -2.69741 2.9636 -568 1 17.7469 15.8806 14.9091 -16.6307 4.82259 1.60218 -569 2 16.7811 16.0196 14.9781 16.1488 -1.66255 -6.01934 -570 2 17.9228 15.7652 13.9648 -0.217809 -0.705292 2.49903 -571 1 13.1074 0.925484 16.7107 3.18003 -6.63181 9.52558 -572 2 14.0398 0.701227 16.9047 -10.9319 3.14101 -7.94235 -573 2 12.6435 0.0729893 16.6565 6.11054 4.53406 -2.82687 -574 1 10.8779 14.5049 7.42771 23.1657 22.4115 -16.2389 -575 2 10.1426 13.9786 7.6854 -20.2069 -15.6201 11.4355 -576 2 11.6544 13.9411 7.50544 0.873985 -2.97227 1.69423 -577 1 17.7332 8.41688 2.16357 9.83329 25.3003 13.1733 -578 2 16.8474 8.49196 2.51389 -11.5025 -5.56634 1.51969 -579 2 17.684 7.86174 1.40275 -6.79002 -17.3841 -17.6814 -580 1 12.5241 7.78132 2.0423 -1.44154 17.0415 -14.1456 -581 2 12.3356 8.69211 1.74465 0.56853 -10.9135 10.1338 -582 2 12.0507 7.22418 1.41137 4.13261 -1.84431 -3.3422 -583 1 12.0402 14.5123 10.5082 -18.3289 -2.04433 -49.0296 -584 2 12.3885 14.3833 9.58045 -11.5085 2.39427 35.0464 -585 2 11.0712 14.6752 10.3612 24.5139 -2.29095 9.58119 -586 1 6.7433 6.75035 15.5111 8.69017 25.9379 21.8943 -587 2 7.64047 7.11596 15.2998 -22.3365 -16.355 4.27733 -588 2 6.42641 7.26782 16.2896 9.37622 -14.6905 -17.8302 -589 1 7.9604 4.42511 13.2728 28.7823 16.7879 24.018 -590 2 7.37747 4.63038 12.5661 -23.4436 4.48442 -18.6585 -591 2 8.25373 5.30295 13.5968 -1.99494 -17.578 -1.9241 -592 1 13.2943 12.2257 14.4027 3.56556 -5.33332 1.41443 -593 2 13.2861 11.2546 14.3815 -5.78887 6.10336 -0.82645 -594 2 13.6298 12.4878 13.5348 -0.194802 0.853385 3.24808 -595 1 14.4975 9.60743 7.32851 -1.81828 -22.5371 -11.9494 -596 2 15.283 10.0905 7.53237 20.8949 12.3364 4.94663 -597 2 13.7862 10.0745 7.73482 -16.3884 10.3496 13.6544 -598 1 12.6855 16.7955 3.35468 10.446 54.0378 -9.24021 -599 2 12.8247 17.4169 4.11373 -2.43161 -22.9959 -18.5255 -600 2 12.7287 17.4093 2.56008 -5.07923 -25.2307 27.5772 -601 1 0.985851 7.00227 17.3383 1.31889 9.4813 -6.51378 -602 2 0.174673 6.82729 17.8428 -2.72668 6.21708 -7.63644 -603 2 0.788987 7.63656 16.6124 1.43967 -10.9643 14.4702 -604 1 12.9703 4.85252 15.7444 36.7131 7.67865 -11.6648 -605 2 13.7444 4.28338 15.4912 -28.1266 12.6425 14.7219 -606 2 13.3848 5.73698 15.8318 -12.3641 -9.92719 -0.136909 -607 1 2.31739 3.41657 5.06312 -13.6796 12.8802 45.0615 -608 2 1.71742 3.03519 5.77756 22.5616 7.27981 -29.9715 -609 2 2.67638 4.25091 5.49055 -8.69432 -27.9074 -22.1065 -610 1 8.14626 10.9014 13.7501 23.1519 -21.2188 51.9658 -611 2 8.18961 10.6456 14.7569 -3.14293 16.1916 -66.8861 -612 2 8.91613 10.442 13.3487 -9.38929 12.2654 3.7561 -613 1 12.9965 1.57692 13.2293 -13.236 30.2614 -33.2276 -614 2 13.5053 1.61767 12.3799 -8.92772 -10.8244 27.0208 -615 2 12.3556 2.33631 13.1194 22.5086 -26.9187 11.5847 -616 1 6.63966 13.684 2.03193 -11.5531 1.65982 24.7971 -617 2 6.01437 14.0711 2.69678 13.9712 -7.1585 -19.9778 -618 2 7.21702 13.1132 2.57076 -4.92077 5.61769 -6.96253 -619 1 15.813 6.37449 12.4855 -26.0384 -19.2076 5.56376 -620 2 16.3133 6.94665 11.9354 17.458 16.492 -16.919 -621 2 16.1081 6.5465 13.3734 10.1637 1.50607 12.5345 -622 1 16.7517 0.683836 9.54032 9.17465 -17.8268 3.86543 -623 2 16.8312 18.3701 9.76674 -11.2714 16.7378 -3.92594 -624 2 16.3182 0.76443 8.67683 0.0107679 -1.03064 0.242674 -625 1 6.19528 11.6935 8.23629 -2.98771 -55.3704 13.0415 -626 2 5.39217 11.4329 8.74625 16.1659 14.5788 -12.0119 -627 2 6.59624 10.789 8.03203 -10.8651 41.6219 1.75135 -628 1 2.78257 8.63233 0.349942 -51.0927 -6.02203 -19.4773 -629 2 2.14734 8.16991 18.3384 31.254 20.3071 31.1367 -630 2 2.20011 9.24624 0.868363 16.6862 -13.9373 -14.0055 -631 1 10.0933 10.2699 6.60791 4.69659 2.91801 -6.95173 -632 2 10.6585 9.65933 7.0984 -2.33853 -1.64778 -0.152736 -633 2 10.478 10.3114 5.71024 -7.38541 0.394324 12.3102 -634 1 6.85971 15.7454 6.78123 4.24276 8.06212 3.90305 -635 2 7.14611 16.2575 7.56121 -6.95129 -7.98507 -8.49325 -636 2 7.04221 16.3283 6.02778 -2.00154 -5.2395 1.03704 -637 1 6.5672 12.9167 5.89107 0.597921 -4.77378 -3.41809 -638 2 6.75629 13.7931 6.22612 0.282518 9.70238 2.49815 -639 2 6.16516 12.4266 6.61937 1.75727 3.9196 -1.62353 -640 1 16.7395 12.5246 9.74847 -3.06854 -10.3396 -13.3378 -641 2 16.803 11.7934 9.09918 0.0574675 11.3505 13.7779 -642 2 17.2471 13.2388 9.35461 0.0307086 0.265441 4.69208 -643 1 6.27963 2.83254 2.76143 -4.73524 -28.0523 14.6006 -644 2 6.37898 3.73989 2.5277 5.16678 22.951 -10.7112 -645 2 5.79937 2.39077 2.0523 -0.657158 4.14199 -3.99187 -646 1 10.6834 2.9997 3.2493 -4.30343 6.66703 3.45031 -647 2 10.3389 3.87773 3.47337 -2.10815 -7.43082 -2.74741 -648 2 10.1644 2.67816 2.50044 1.52937 0.706493 -1.87803 -ITEM: TIMESTEP -100 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.77244 6.59569 17.9763 -3.45079 -15.6041 -9.13306 -2 2 7.88004 6.49722 18.3444 6.65526 3.83231 -3.73646 -3 2 8.88832 5.875 17.3232 0.339998 10.7344 11.2284 -4 1 0.232197 8.43163 6.74931 6.06809 -9.75314 40.4456 -5 2 0.255717 8.25928 5.82997 0.568886 -7.03857 -37.2819 -6 2 0.690537 7.6579 7.15764 -12.6716 20.3857 -3.7924 -7 1 8.73054 0.448274 6.96197 0.757688 5.19807 -2.99354 -8 2 9.64384 0.493158 6.62895 -11.5479 0.592924 -0.0248858 -9 2 8.1978 0.998025 6.35807 9.15448 -7.13553 5.61176 -10 1 6.40593 1.75267 11.8149 38.8296 -3.08614 -8.28972 -11 2 5.81968 2.38515 12.1727 -25.8813 19.5399 13.38 -12 2 5.91601 0.958217 11.6787 -14.9693 -21.4487 -5.83463 -13 1 6.93553 5.46707 2.3717 -29.4847 3.29264 10.9289 -14 2 6.2293 5.77948 3.0367 33.3819 -5.43232 -34.2308 -15 2 6.73101 5.82483 1.47662 0.276644 1.33511 28.97 -16 1 16.2706 10.1725 16.0328 16.576 -12.0275 -13.9735 -17 2 17.1689 10.3287 15.6909 -13.6837 1.56601 5.28727 -18 2 15.9002 11.0264 16.2303 -5.40144 13.1923 2.47446 -19 1 10.8573 14.9713 2.3127 -4.53536 -0.807355 -13.4682 -20 2 10.8458 14.5197 3.15612 -3.95698 -5.41896 6.20362 -21 2 11.2908 15.8056 2.48855 3.23834 4.77246 6.19277 -22 1 17.2232 8.21136 11.0033 2.73792 2.45641 -7.11401 -23 2 16.6726 8.88418 11.4331 2.86084 -2.93597 -0.581414 -24 2 17.9525 8.69866 10.5809 -6.6523 -2.55116 4.88578 -25 1 14.5937 16.0509 16.2923 16.8919 1.55785 -12.0612 -26 2 13.6919 16.3738 16.3176 -7.99874 0.738503 2.77307 -27 2 14.7362 15.4806 17.0483 -6.38665 -4.70858 10.3974 -28 1 12.1782 13.2488 0.556058 -6.41896 9.17153 -4.9038 -29 2 11.8393 13.4134 18.3136 3.64438 -6.73296 -6.87976 -30 2 11.6781 13.8768 1.08938 4.30308 -0.940018 9.70193 -31 1 9.32636 5.50189 3.85673 -23.6707 -6.9557 11.6523 -32 2 8.85207 5.35955 4.73387 10.6863 3.91607 -36.7024 -33 2 8.65492 5.41152 3.1282 11.356 3.18621 25.5004 -34 1 1.53424 3.89903 11.544 -4.66799 23.5976 14.1629 -35 2 1.33558 4.79151 11.9229 9.77101 -18.0042 -9.49869 -36 2 1.78943 3.33535 12.2834 2.68741 0.460061 1.88957 -37 1 2.11036 6.99869 8.11066 2.48315 -17.2899 2.96853 -38 2 2.57184 7.49315 8.78305 3.29023 12.1045 5.89357 -39 2 2.1177 6.10606 8.48449 -3.4025 -1.3508 -8.01694 -40 1 5.18347 4.46977 7.78792 -2.57538 4.03359 -5.12796 -41 2 5.37117 3.51932 7.65443 -4.82345 11.4027 -0.558597 -42 2 4.53495 4.79047 7.12216 11.4175 -13.4448 8.55636 -43 1 3.42716 2.88114 17.3924 1.12201 37.8538 -2.09818 -44 2 4.03218 3.21565 16.6954 -8.80258 -2.8612 13.6459 -45 2 2.96175 3.68375 17.7714 12.3959 -28.5801 -12.8282 -46 1 7.56049 5.45137 6.19682 -11.2764 11.7759 39.3451 -47 2 8.17338 6.02323 6.733 -17.9712 -15.9787 -15.2388 -48 2 6.83707 5.19934 6.84169 25.8687 -1.03041 -23.6459 -49 1 9.81873 7.03274 12.0818 18.6926 1.80354 21.1658 -50 2 10.1168 6.17447 11.801 2.37707 -8.57843 -5.75387 -51 2 9.13705 7.28384 11.4839 -21.9155 5.9942 -18.2818 -52 1 13.9782 3.81734 8.11005 -6.38125 -7.14222 -11.0636 -53 2 13.4268 4.53125 7.77431 4.97705 1.71109 -4.47031 -54 2 14.3288 4.12395 8.93436 6.50574 7.00298 17.9277 -55 1 4.54162 17.1358 3.87887 10.9044 35.7056 -0.341992 -56 2 5.36932 17.5648 4.19271 -11.2647 -17.0231 -6.60056 -57 2 4.14672 17.8103 3.27983 -0.0256371 -21.9717 9.98561 -58 1 16.2123 16.5489 10.6095 26.1835 -5.76397 -19.4616 -59 2 15.4589 16.7003 11.1416 -23.8325 7.35421 23.2226 -60 2 15.8886 15.8767 10.0022 2.98718 1.98497 -7.14015 -61 1 1.93449 4.79928 0.00082377 17.3961 -4.98991 5.57961 -62 2 2.67896 5.07161 0.592242 -22.0191 7.26131 -10.4701 -63 2 1.68005 5.53286 18.0583 5.78187 -2.17332 10.5029 -64 1 11.1761 13.3033 16.4476 20.6858 -29.5101 -20.5449 -65 2 10.7502 12.4348 16.5818 -0.505604 15.8506 2.04497 -66 2 11.8189 13.0874 15.7254 -14.483 14.0049 15.9552 -67 1 10.0082 10.9133 16.7377 -9.76065 -12.5647 6.43928 -68 2 10.4104 10.0696 17.0143 -3.0625 14.8211 -5.5238 -69 2 9.04798 10.758 16.6751 14.6534 4.77532 0.819581 -70 1 11.8926 17.5507 13.5059 -15.5524 -14.4544 -0.25773 -71 2 12.4585 17.1847 12.8152 4.41482 5.53476 3.60851 -72 2 11.9755 18.5016 13.5139 9.00416 11.9454 -7.12981 -73 1 6.39659 9.54323 12.3526 -12.6063 6.46711 4.93213 -74 2 6.97402 9.29797 11.635 9.25294 -5.21247 -6.5221 -75 2 6.9248 10.0607 12.9773 -1.49192 -5.83682 -8.37915 -76 1 16.2827 12.8664 2.8283 0.430065 -24.2056 0.300325 -77 2 17.1271 13.2094 2.55074 10.9303 3.80489 0.0707423 -78 2 15.7284 13.6342 2.87288 -15.0446 12.1841 2.12753 -79 1 0.782434 12.8185 5.85612 -33.4557 3.27495 -26.778 -80 2 1.12737 12.9122 4.94214 -3.16706 -8.15793 13.9432 -81 2 18.4302 12.7528 5.74133 33.3816 -1.67566 5.80796 -82 1 5.29416 16.3645 18.462 -0.365113 -1.85929 1.37874 -83 2 5.65117 15.5929 17.9841 -1.41418 12.24 9.00358 -84 2 5.90904 16.5787 0.535619 -2.78951 -3.81837 -4.76209 -85 1 0.717617 7.68269 4.16298 45.78 12.5398 -25.9452 -86 2 0.140595 7.95484 3.42088 10.68 -3.85526 14.32 -87 2 1.67421 7.98176 3.89702 -61.12 -15.169 17.2669 -88 1 3.20538 9.16537 6.53153 -16.7997 -26.3462 11.633 -89 2 3.63886 8.66012 7.25517 -10.7634 14.1338 -16.8685 -90 2 2.28456 8.785 6.4428 29.8979 17.6904 5.8263 -91 1 7.3492 10.4558 16.1821 -32.1717 -5.51262 30.2531 -92 2 6.6595 11.1272 16.0448 13.9154 -6.26319 -1.99334 -93 2 7.03952 9.99344 16.9918 7.69449 10.9592 -10.5833 -94 1 10.9926 0.857119 5.02234 -5.32556 5.69944 -21.4369 -95 2 11.0071 1.72344 4.58448 5.20867 -2.07691 11.6276 -96 2 10.6449 0.320945 4.28448 4.96755 -3.65716 14.4683 -97 1 4.17972 2.99732 13.1563 8.08367 -30.8511 5.02994 -98 2 4.53886 3.3528 13.9956 -8.94088 -10.2248 -10.148 -99 2 4.12323 1.98418 13.2207 2.50903 42.0947 6.54014 -100 1 8.52337 10.2728 1.80778 10.3789 -10.908 24.8689 -101 2 8.43412 10.9106 2.54849 -2.4679 -8.46295 -11.8092 -102 2 8.72683 9.4118 2.24878 -4.48166 20.4458 -7.62428 -103 1 10.3146 1.66303 15.4651 0.0280032 6.46587 3.16016 -104 2 11.2365 1.5769 15.7049 7.71736 -2.87845 -0.628854 -105 2 10.2832 2.03916 14.5766 -0.873711 -2.30994 -1.44208 -106 1 2.60872 12.9688 7.93078 -1.0685 2.90827 1.70102 -107 2 3.08524 13.7852 7.70925 1.81136 -8.54773 -5.41906 -108 2 2.07592 12.7429 7.1537 2.1601 3.22826 4.8584 -109 1 3.84139 11.714 4.98357 -9.2182 -6.48315 2.00023 -110 2 3.59649 11.1336 5.73363 3.13206 7.92599 -15.0555 -111 2 3.08391 11.75 4.36582 7.48234 -0.753218 11.1676 -112 1 6.65636 14.539 16.9808 1.14971 -3.74934 -0.345026 -113 2 7.45699 15.0461 17.1534 0.734042 -3.82079 -1.22553 -114 2 6.35462 14.7758 16.0963 4.10604 -0.420587 -1.60546 -115 1 14.2186 14.4753 3.18712 8.31434 -1.03143 -11.3814 -116 2 13.7635 15.2982 3.34662 -3.59872 10.6386 -1.06184 -117 2 13.8465 13.8568 3.80574 -6.38377 -9.35153 11.7656 -118 1 8.76639 18.036 16.1575 -17.2352 -7.71273 4.18589 -119 2 9.29865 17.253 16.446 -1.99578 26.3863 -16.3924 -120 2 9.21082 0.13577 15.7005 10.7734 -16.3176 12.3305 -121 1 4.70057 1.84937 4.90583 -5.59427 22.8387 -36.2464 -122 2 3.793 2.25175 4.86575 28.8401 -10.2604 4.23254 -123 2 5.1801 2.18711 4.08016 -18.9233 -12.3263 38.2061 -124 1 15.0501 12.6021 16.5687 -12.0311 0.26828 5.88874 -125 2 14.6786 12.8761 17.4109 9.53333 3.55003 6.01908 -126 2 14.2645 12.5148 16.0221 4.98358 -1.43573 -15.5641 -127 1 15.7004 18.5129 16.8573 39.713 -3.42746 23.3516 -128 2 16.4681 18.7143 17.5055 -38.5977 -15.0096 -30.817 -129 2 15.6109 17.5396 16.7903 -2.54574 14.9499 6.02131 -130 1 1.36802 1.35817 16.6529 -7.19601 7.74866 13.6684 -131 2 2.15913 1.86948 16.876 -3.57304 -8.28302 -6.01627 -132 2 0.751389 1.61649 17.3659 4.93092 -7.13328 -12.7379 -133 1 18.2443 4.33431 15.8699 4.87602 -2.4936 -15.9817 -134 2 17.8369 3.63124 15.3424 2.32992 6.4949 4.25729 -135 2 0.452078 4.51482 15.4394 -9.42811 -2.49011 8.2103 -136 1 12.0529 17.1173 16.1421 -28.5646 -13.5401 15.8604 -137 2 11.3287 16.6705 16.6559 24.6179 11.2855 -13.6919 -138 2 11.708 17.1501 15.239 10.7504 0.848438 1.34073 -139 1 16.0751 2.69533 18.2299 -16.8426 22.7601 -19.9608 -140 2 15.7518 3.52741 18.6545 8.16925 -19.768 -14.2608 -141 2 15.768 2.75869 17.2894 6.47211 -5.43997 24.4047 -142 1 6.70105 13.7211 10.0493 -2.92253 -3.29615 13.924 -143 2 6.49616 13.3451 10.9223 2.46715 2.87816 -3.90822 -144 2 6.5701 13.0016 9.42848 5.58743 -2.71244 -4.10916 -145 1 10.1642 18.4563 2.66846 -6.4553 9.35236 -16.0973 -146 2 10.4494 0.522706 2.05557 -0.598662 -14.7868 7.93587 -147 2 9.23943 18.2921 2.43567 5.35466 0.524311 4.08806 -148 1 3.08905 17.6286 6.23363 28.1073 -1.15148 23.9606 -149 2 2.19758 17.5876 5.91536 -10.6529 4.22104 -18.8026 -150 2 3.7136 17.7221 5.50184 -12.297 -3.14114 -7.6924 -151 1 12.6187 16.7784 7.83399 -8.24743 2.38577 1.37984 -152 2 11.9273 16.0794 7.74003 7.37944 21.7069 5.85683 -153 2 12.3535 17.4638 8.48865 -0.622135 -17.7991 -6.24189 -154 1 14.8741 15.2807 8.33754 11.6667 3.93031 -5.87838 -155 2 14.2607 15.9458 8.0029 -4.6938 -2.09697 8.01324 -156 2 15.5465 15.2244 7.63778 -8.32879 0.363275 5.25782 -157 1 17.8358 18.3077 0.207666 -46.6557 3.82667 -12.4063 -158 2 18.5381 17.6928 0.20107 34.3258 -19.0599 -1.41311 -159 2 18.1099 0.429917 0.68066 12.6369 19.0779 11.4558 -160 1 0.768971 10.519 1.45234 -14.3967 -19.3664 19.1268 -161 2 -0.0407552 10.0454 1.78172 23.5075 9.70284 -14.2764 -162 2 0.503185 11.1892 0.827858 -7.10365 8.12718 -9.46819 -163 1 1.82037 12.3064 3.2607 -0.411525 2.12628 17.6018 -164 2 1.36119 11.682 2.70611 -2.67447 -10.2614 -7.1426 -165 2 2.03731 13.0482 2.69872 0.079619 5.20365 -3.96737 -166 1 0.725717 17.3003 4.98992 32.4002 3.58468 -34.9181 -167 2 -0.000639544 17.8885 5.08952 -19.7566 14.3988 12.6832 -168 2 0.713313 16.5777 5.58791 -15.4184 -21.9192 25.4801 -169 1 0.951486 0.797441 9.37101 14.826 11.188 -16.0996 -170 2 1.14791 0.588384 10.2838 -3.41112 -8.44303 11.2353 -171 2 0.0745467 0.497625 9.13864 -8.88294 -4.64793 9.22513 -172 1 16.8073 2.38946 13.4769 5.39787 -10.4284 -8.99471 -173 2 17.0506 2.69304 12.5747 -8.0967 -7.05722 13.8788 -174 2 16.5161 1.45381 13.4188 4.66162 13.0486 -2.08534 -175 1 2.62912 16.0502 12.0784 8.40953 -12.472 -10.7904 -176 2 3.04385 15.7269 12.8881 -2.37218 0.184289 -5.79457 -177 2 3.10949 15.6337 11.3228 -8.7582 6.42497 16.6586 -178 1 16.3457 15.4302 6.12389 30.9011 24.8554 -18.1041 -179 2 17.2992 15.5349 6.36757 -22.0844 -7.23183 -0.993592 -180 2 16.19 16.1865 5.50068 -1.85714 -20.6143 14.9819 -181 1 5.77873 5.21745 11.785 11.0193 -20.9315 -11.6683 -182 2 5.50793 5.92484 12.3546 -4.36629 16.5013 7.19057 -183 2 5.27867 4.45162 12.0794 -6.37659 -1.59945 -1.70387 -184 1 15.1747 4.94504 0.761547 -29.5175 -4.13494 28.6724 -185 2 14.9952 4.57194 1.67189 6.69018 16.901 -24.5633 -186 2 14.3176 5.30548 0.449447 18.0211 -8.94221 4.63226 -187 1 16.4144 16.461 1.77501 8.34865 -5.69196 -8.65308 -188 2 16.356 16.7636 2.67626 -8.71628 3.92983 13.8981 -189 2 16.7832 17.2073 1.29403 -0.614878 1.7319 -3.63708 -190 1 0.136057 4.8659 3.98965 34.6037 22.2365 -2.60366 -191 2 0.554963 5.79058 3.9624 -19.788 -38.6093 6.27627 -192 2 0.840291 4.21253 4.20207 -10.6708 20.7839 -4.14843 -193 1 2.91044 15.0804 15.1041 7.34684 -10.5058 14.2682 -194 2 2.90482 14.7198 16.034 -7.41786 16.0657 -24.8201 -195 2 2.46761 15.9418 15.099 -2.49045 -2.68752 9.6724 -196 1 0.98952 14.6361 9.40184 3.41519 -3.90395 6.55514 -197 2 1.54705 13.945 9.00075 -6.08548 3.23571 10.1521 -198 2 0.78947 14.3674 10.3125 0.535168 -4.82993 -11.1122 -199 1 13.5676 16.5089 11.5672 -19.673 9.58551 -20.9583 -200 2 13.2883 17.2623 10.9814 5.35041 -18.2182 15.9177 -201 2 13.0352 15.7491 11.2513 9.15027 7.77217 2.32965 -202 1 4.84709 1.60354 0.665871 -13.2454 -7.94988 -14.2061 -203 2 4.37724 2.10746 -0.0295305 4.1335 -5.07179 15.4313 -204 2 4.23428 0.890311 0.93575 7.29231 10.3056 3.49355 -205 1 1.57562 18.6232 11.9448 -9.54215 3.4719 -19.1533 -206 2 1.53947 0.452662 12.7669 0.622104 8.67092 13.3018 -207 2 1.94164 17.7639 12.1401 7.67295 -5.68018 1.31967 -208 1 11.3828 10.0809 4.23132 25.5406 -0.783734 -33.5194 -209 2 11.2477 10.3841 3.29047 7.40472 -5.62792 30.1478 -210 2 12.3604 9.90108 4.31318 -36.068 9.82931 1.34024 -211 1 8.1924 12.225 3.79726 -5.69748 14.5101 56.1678 -212 2 9.05523 12.5573 4.13122 -12.2475 -6.42112 -18.1901 -213 2 7.61811 12.3317 4.63279 18.664 -10.6547 -44.172 -214 1 14.6446 4.04033 3.3856 3.29585 4.20735 14.8065 -215 2 15.1799 4.13354 4.21231 -10.8641 -1.34483 -21.0767 -216 2 13.7289 4.27483 3.60977 8.83721 -0.102893 1.13309 -217 1 5.73789 1.70847 7.633 -45.2268 -33.2589 19.0394 -218 2 5.00558 1.12579 8.07813 40.2552 34.7696 -21.6936 -219 2 5.52319 1.67762 6.69069 2.06189 0.609235 -2.30714 -220 1 17.8554 0.94247 4.83325 2.84508 1.94772 -6.32822 -221 2 18.4375 1.13729 4.06994 -6.68522 3.20321 14.3473 -222 2 17.8361 1.70281 5.4359 2.52705 -5.98387 -7.60558 -223 1 6.82607 9.13014 4.53731 -2.03949 -2.27606 -0.824268 -224 2 6.749 9.37751 5.45829 -4.27203 4.05265 7.19029 -225 2 7.76352 8.95198 4.44117 4.86868 -1.78157 -6.05796 -226 1 2.39805 14.6397 2.05874 17.0918 -1.49078 4.46086 -227 2 3.17145 14.6314 2.66377 -10.8679 0.525641 -12.6634 -228 2 2.72903 14.4183 1.17543 -1.81421 4.03234 5.90777 -229 1 17.1796 12.9575 13.0281 -10.0626 2.91445 0.0973403 -230 2 16.3048 13.3397 13.2675 20.7192 2.62525 -4.36947 -231 2 17.7682 13.6617 12.6978 -15.1419 2.46765 5.43564 -232 1 14.7925 10.5715 1.51204 -8.6843 -36.4521 -19.1925 -233 2 15.3686 11.2103 1.85793 27.186 33.4644 17.5702 -234 2 13.9217 10.9161 1.62765 -18.2001 7.18743 0.677482 -235 1 5.63756 6.65584 4.53835 -5.70194 -14.7917 8.95129 -236 2 5.96892 7.55557 4.50237 4.06113 5.5935 -1.33512 -237 2 6.19689 6.19506 5.18786 2.48768 6.43185 -8.34619 -238 1 8.1035 8.32015 10.3633 -6.06951 -1.51391 13.5103 -239 2 8.71051 8.88696 9.88772 3.75134 6.39998 -5.242 -240 2 7.4427 8.01108 9.7382 -0.891776 -1.59521 -4.95879 -241 1 13.4554 18.4382 5.64567 -23.0826 -2.6609 26.3697 -242 2 12.6541 0.350227 5.51512 12.1971 -9.37205 -2.29397 -243 2 13.2308 17.8847 6.43702 5.12544 9.06169 -21.995 -244 1 0.0481459 2.53289 0.450073 0.762545 20.3906 -8.36614 -245 2 17.7393 2.57826 18.829 23.3906 9.65711 1.86789 -246 2 0.50996 3.41343 0.303855 -21.6669 -27.8541 1.68488 -247 1 12.9745 10.8048 9.65469 -32.5048 41.5261 -13.285 -248 2 12.0083 11.0976 9.65119 33.8953 -25.1931 3.11551 -249 2 13.0333 9.87229 9.85209 -8.8072 -6.07099 4.09073 -250 1 0.527116 12.3319 11.2575 10.4347 -0.622496 2.4881 -251 2 18.2313 12.2915 11.4294 -10.2968 -1.46033 -6.74513 -252 2 0.909084 12.5363 12.117 7.12796 0.366826 -3.41572 -253 1 5.28415 7.34725 13.2845 -6.32664 2.65038 2.55184 -254 2 5.64713 8.17412 12.9655 4.82658 4.12789 -9.57053 -255 2 5.74627 7.2293 14.1116 0.316635 -7.58532 9.69513 -256 1 1.16454 6.74183 12.03 -13.1625 -42.3004 -9.02199 -257 2 0.295417 6.98712 11.7254 -9.09418 5.46945 -3.0829 -258 2 1.57891 7.53521 12.2772 19.8541 36.5775 12.6901 -259 1 15.5783 9.75012 12.4577 9.71681 16.8235 16.5595 -260 2 15.2431 10.6351 12.2158 0.950441 -15.6258 3.07953 -261 2 16.0853 9.89705 13.2804 -12.0519 -4.92211 -13.1427 -262 1 16.5993 12.6285 5.60521 -10.2494 37.6021 -45.7262 -263 2 16.4242 13.6113 5.62967 5.67224 -29.3823 14.3376 -264 2 16.441 12.4706 4.63081 7.92181 -5.25591 31.2114 -265 1 6.41284 9.90681 0.119653 0.515871 -10.7086 -9.9123 -266 2 5.64934 10.3727 0.465056 -3.06655 2.33505 3.46562 -267 2 7.14462 10.1266 0.702846 2.16363 1.41956 4.36049 -268 1 12.2095 5.93838 4.00309 -11.5544 -2.90268 -3.08172 -269 2 12.2942 6.66752 3.37735 2.08742 0.382808 1.33145 -270 2 11.2587 5.74648 4.01779 6.74513 0.670066 1.17813 -271 1 0.342924 12.9268 0.00967172 -2.71894 -2.13654 5.95194 -272 2 18.7348 13.4393 0.793746 3.88983 0.588143 -5.53597 -273 2 18.4589 13.2921 17.9296 1.41778 -5.28425 5.34754 -274 1 3.57599 18.7244 8.67011 -7.57313 7.8026 -17.3863 -275 2 3.53053 18.3214 7.79351 4.94999 -5.98969 2.51912 -276 2 2.6975 0.472694 8.72681 1.72246 -0.921876 11.7862 -277 1 7.19816 17.4543 4.42938 13.0422 27.6578 -13.842 -278 2 7.51541 18.3714 4.6455 -6.70989 -26.1973 -6.43912 -279 2 7.34255 17.3635 3.4592 -3.95356 0.0926602 20.0901 -280 1 9.24276 17.181 12.1874 27.1924 -9.91753 -12.8104 -281 2 9.16544 16.536 11.4403 4.06483 10.4089 22.9332 -282 2 10.1989 17.1789 12.4847 -33.3611 -0.423317 -5.22003 -283 1 13.2427 13.2324 7.99028 -4.63127 -11.2433 10.7708 -284 2 13.2975 12.5097 8.63573 0.309708 1.2863 -7.28868 -285 2 13.9184 13.8596 8.25103 7.01778 4.96536 -0.211076 -286 1 14.7706 2.86972 15.5058 12.3246 -20.976 -18.3849 -287 2 14.0341 2.28041 15.2496 10.8751 5.18171 6.07562 -288 2 15.4548 2.72916 14.8136 -15.3015 9.06101 10.4071 -289 1 9.96013 15.6554 16.9624 -0.416257 -4.3558 -3.6035 -290 2 10.3061 14.8055 16.6414 -1.75696 6.53817 2.71112 -291 2 9.61308 15.4752 17.8389 -3.07369 -3.40172 1.73448 -292 1 11.2206 8.54091 16.6271 11.2119 0.246209 -0.153837 -293 2 10.3853 8.13843 16.425 -12.7378 -7.75768 -8.20822 -294 2 11.7159 7.85532 17.0695 3.92811 -4.5145 7.83184 -295 1 4.19128 18.3534 16.7936 -2.0541 -15.6573 2.75359 -296 2 4.49896 17.6946 17.4386 1.3239 2.14246 -6.87061 -297 2 4.3476 0.553135 17.2025 -0.294224 9.43754 2.6314 -298 1 2.38271 4.321 8.90759 20.0465 -16.3105 29.2362 -299 2 3.33364 4.03277 8.87737 -27.5446 13.4253 -3.78204 -300 2 2.08958 4.1083 9.83354 7.71669 6.29647 -26.7475 -301 1 9.9842 10.4369 9.88352 -17.0195 21.6351 -0.0387615 -302 2 9.44133 11.1731 9.47934 17.4922 -21.0458 18.4718 -303 2 9.94225 10.4854 10.8652 2.27572 1.94662 -18.6097 -304 1 9.85899 0.920399 10.8075 0.162278 -2.63975 1.09763 -305 2 9.48302 0.0750215 11.0855 -2.58178 2.3482 3.77053 -306 2 9.21377 1.33985 10.2254 -0.0206645 -1.54215 -2.59695 -307 1 9.16055 15.229 10.2075 -19.4407 -6.65372 -14.862 -308 2 8.92137 15.8821 9.51239 -0.317996 -13.1788 14.0466 -309 2 8.43697 14.5477 10.1944 18.1534 21.6077 -0.815821 -310 1 0.71674 9.75329 10.1461 2.10813 23.2969 8.50765 -311 2 0.819344 10.7283 10.3167 -3.94998 -28.3852 -4.44668 -312 2 1.15296 9.53542 9.32246 0.728257 4.55427 -3.87479 -313 1 17.2456 4.88922 8.01698 -15.6269 -0.477795 25.7007 -314 2 16.4423 5.19943 8.52213 28.7194 -9.29348 -15.89 -315 2 17.7804 4.31587 8.60398 -15.5446 9.64156 -7.98894 -316 1 14.822 14.6129 0.044879 1.26259 -7.26488 27.1569 -317 2 15.5503 14.8635 0.654609 -16.5042 1.70925 -13.2775 -318 2 14.1019 14.3181 0.644441 11.2495 5.19015 -13.4399 -319 1 3.93398 11.151 9.56657 -13.0999 1.1143 6.92396 -320 2 3.8819 11.1389 10.5379 -0.108421 8.58768 -6.25849 -321 2 3.2885 11.8101 9.24754 8.95434 -7.44407 0.420275 -322 1 11.481 10.7372 1.49136 -12.2308 11.5287 -6.19882 -323 2 11.6479 11.6347 1.11375 -3.03535 -20.3842 8.82813 -324 2 10.5208 10.5745 1.38561 13.1816 3.92224 -1.496 -325 1 13.1382 7.21836 12.5396 -14.3564 7.08975 0.177427 -326 2 14.0771 7.12045 12.4061 13.875 -7.92794 3.07029 -327 2 12.7619 6.3345 12.5945 1.25366 -4.42296 3.81153 -328 1 9.68698 1.99848 0.824055 10.3256 0.727137 24.2023 -329 2 8.81917 1.78721 0.50968 -15.0497 -1.62599 -5.65 -330 2 10.155 2.38703 0.0980655 8.32187 5.69202 -13.7925 -331 1 10.602 13.3929 4.55586 17.4753 0.473987 25.0493 -332 2 11.4671 12.9458 4.66597 -13.9744 4.33191 -5.6004 -333 2 10.4831 13.8198 5.42698 -1.33045 -1.26907 -13.5894 -334 1 14.5505 1.55995 10.9504 0.793491 3.39408 -6.18689 -335 2 15.3506 1.17936 10.5364 -11.0229 12.1378 4.59402 -336 2 14.5582 2.53024 10.8225 7.4254 -12.0179 1.55597 -337 1 14.4508 12.0407 11.6074 10.4267 -5.99888 -36.1251 -338 2 15.2905 12.2256 11.0848 -31.5625 -1.98982 15.431 -339 2 13.8033 11.6041 10.9773 26.0423 16.8772 21.3357 -340 1 8.16091 5.15464 9.81808 -31.1733 -3.04727 19.1057 -341 2 7.28259 5.21015 10.2725 23.9466 4.77499 -10.0641 -342 2 8.23945 4.21356 9.63446 4.25293 -1.90524 -4.29988 -343 1 1.57078 16.9857 18.5145 2.11582 4.65495 -1.34384 -344 2 1.81738 17.3492 17.6562 0.32294 -2.46744 1.69741 -345 2 1.87051 16.0745 18.5076 0.982883 -4.60963 -1.80737 -346 1 1.40224 17.4231 15.3612 30.835 -28.8708 -16.9337 -347 2 1.58171 18.2262 15.8024 1.01568 35.607 16.5514 -348 2 0.474852 17.284 15.3634 -28.8421 -6.17683 0.802216 -349 1 3.44554 5.70547 6.04619 4.62282 22.475 -0.524537 -350 2 3.1428 6.44974 6.61309 0.90031 -17.6364 -10.4242 -351 2 4.06586 6.09018 5.39907 -5.11167 -0.757253 7.03456 -352 1 12.635 9.5385 14.2471 10.4135 -57.691 -2.75625 -353 2 13.0561 8.75521 13.7543 -17.7171 41.3381 15.7803 -354 2 12.3533 9.10151 15.082 0.88858 17.3566 -13.7461 -355 1 4.11217 15.1814 7.19429 24.0597 14.9458 -6.20919 -356 2 3.65166 15.9525 6.80506 8.00815 -8.18076 7.53786 -357 2 5.09537 15.3539 7.08579 -34.9804 -3.92885 1.78443 -358 1 0.830872 8.84313 15.1657 1.50937 4.0339 -6.81168 -359 2 0.547306 9.77972 15.0966 9.11455 -14.6477 -1.64448 -360 2 1.6109 8.72602 14.589 -11.0561 6.95599 3.23137 -361 1 12.8981 8.26079 10.0923 10.5692 -21.7103 -4.02448 -362 2 13.6229 7.70102 9.77244 -0.136865 10.7899 -7.02632 -363 2 12.7945 7.93077 10.9815 -6.52785 3.68747 11.7154 -364 1 15.1981 8.09018 3.38532 -13.0459 -52.6521 2.11346 -365 2 14.5247 7.61376 2.86907 3.36606 26.685 -8.7616 -366 2 15.3386 7.39586 4.05885 15.5852 26.7124 4.01456 -367 1 17.1365 6.7605 0.0284285 -19.4133 2.32297 -2.08842 -368 2 16.6422 5.96523 0.300426 11.1165 9.80228 -2.81184 -369 2 16.4267 7.37993 18.3943 16.5678 -7.00446 5.84521 -370 1 8.97527 7.00353 7.90402 -12.8517 -1.3564 7.9131 -371 2 9.8962 7.25242 7.83012 8.98921 2.98997 4.36252 -372 2 8.82463 6.62979 8.79874 5.5237 0.780274 -18.1173 -373 1 12.5342 0.599732 1.22272 7.37234 -11.2249 5.10795 -374 2 13.3221 0.863275 1.71742 -3.27048 6.46822 -3.34517 -375 2 12.885 0.18837 0.429335 -4.8121 3.35952 -2.50919 -376 1 5.70486 15.0289 14.4325 -10.0966 26.0987 -8.04315 -377 2 4.75654 15.1126 14.6498 8.83064 -2.51751 -1.0487 -378 2 5.99172 15.9344 14.1552 -2.67099 -19.6319 8.34541 -379 1 3.68772 6.51886 1.67786 -9.02664 17.532 -4.1283 -380 2 3.3123 7.35563 1.32777 6.95322 -18.4916 -0.718273 -381 2 3.69933 6.70385 2.62114 4.49099 -5.2411 1.79351 -382 1 3.84119 11.2683 12.301 -11.0219 1.87445 3.30422 -383 2 4.7083 11.6207 12.5295 0.62865 1.71432 1.43021 -384 2 3.16952 11.829 12.7259 9.18863 0.324364 -2.3982 -385 1 5.33774 3.90131 15.6575 3.88008 58.1131 -0.302695 -386 2 6.0029 3.30263 15.356 18.6017 -19.7261 -0.90724 -387 2 5.77609 4.81808 15.6348 -20.8077 -39.2998 1.51453 -388 1 13.9476 10.0954 4.76119 43.1598 -13.631 -14.8551 -389 2 14.3099 9.89525 5.64952 -11.5358 -2.78357 -16.2598 -390 2 14.5437 9.62633 4.09138 -26.3956 16.5702 30.5617 -391 1 7.47949 17.2779 8.9575 1.27559 12.2273 10.3752 -392 2 6.80648 17.541 9.63427 13.3482 -0.885269 -20.4433 -393 2 7.81637 18.0666 8.4826 -8.0179 -7.75644 7.92076 -394 1 4.60365 14.3557 3.73459 -2.67085 -0.0597314 40.4087 -395 2 4.53549 15.2621 4.14744 4.43815 -28.6634 -11.7113 -396 2 4.62044 13.6529 4.46513 -1.80956 31.3212 -27.6241 -397 1 14.2431 7.29194 15.9057 25.6353 16.9765 2.1683 -398 2 15.0475 7.32515 15.3368 -17.0197 -3.00413 14.2387 -399 2 14.4656 7.87429 16.6673 -6.53416 -15.6271 -13.0076 -400 1 2.96496 18.4208 1.99119 15.7852 32.1682 20.7835 -401 2 2.67672 17.8955 1.28044 -15.5564 -27.5435 -28.9446 -402 2 2.23493 0.385121 2.17733 5.2916 -3.96739 2.45348 -403 1 7.98476 1.5873 4.50407 1.38949 2.52923 0.695279 -404 2 7.37343 2.0449 3.91068 5.19751 -1.80104 2.00097 -405 2 8.86519 1.9238 4.29038 -5.22298 -3.29695 -0.501883 -406 1 2.57117 14.1691 17.7571 1.007 -17.2424 4.53378 -407 2 1.90219 13.4698 17.9606 14.5878 19.4169 -2.4542 -408 2 3.44824 13.7555 17.8862 -10.6426 1.83574 2.42644 -409 1 1.00451 2.03285 13.8784 10.3502 2.39599 -10.3714 -410 2 1.16144 1.84563 14.7992 2.97823 -2.88805 14.0985 -411 2 0.0700994 1.90667 13.7535 -13.5508 1.82952 -2.05389 -412 1 4.33902 0.200757 13.8843 13.0721 -10.005 -1.30306 -413 2 5.22858 18.4296 13.858 -15.0619 9.43809 1.75921 -414 2 3.93054 18.5168 14.6942 4.28146 4.19272 1.73225 -415 1 7.39543 1.05973 18.4904 -6.66444 -3.84456 4.72925 -416 2 7.66739 0.634389 17.6825 2.48525 -3.87431 -15.5197 -417 2 6.44311 1.20989 18.4324 3.08246 -0.882049 5.31666 -418 1 15.7652 18.4035 13.928 -3.86344 6.1861 11.5309 -419 2 14.8535 18.6979 13.7607 9.26883 -6.83338 6.65234 -420 2 15.8985 -0.310566 14.8997 -7.7909 7.80446 -17.2978 -421 1 10.2952 4.64795 16.1844 -42.7729 -17.7833 -2.18791 -422 2 11.2045 4.84382 16.2798 37.5776 1.06228 1.58962 -423 2 10.2217 3.67206 16.1998 1.46017 15.0252 -2.22652 -424 1 15.8927 17.6472 4.46477 -15.4234 23.5431 17.5975 -425 2 16.4754 18.4255 4.65687 -16.3789 -18.5079 -6.3799 -426 2 14.9773 17.9018 4.78742 33.6258 -6.52099 -13.8394 -427 1 6.90155 17.6195 13.966 46.0362 -18.082 7.69792 -428 2 7.5054 17.5909 14.7751 -24.8486 6.04139 -28.3759 -429 2 7.50943 17.3755 13.214 -16.8133 11.713 21.5591 -430 1 13.2082 6.37265 6.52765 -13.548 -6.29238 7.5029 -431 2 14.0171 6.83631 6.34759 17.8515 4.0742 0.884882 -432 2 12.7912 6.26458 5.66961 -1.80962 -1.49443 -3.94736 -433 1 7.85263 2.26509 9.52735 -7.99894 -5.84405 -22.7054 -434 2 7.25184 2.06178 10.2504 -3.996 2.15095 3.09306 -435 2 7.39499 1.97805 8.69805 10.2818 7.88442 20.3126 -436 1 15.1135 14.8377 13.7906 -14.0873 7.85215 4.54273 -437 2 14.8065 15.1503 14.6696 4.89633 -5.66092 -15.9193 -438 2 14.526 15.2486 13.1323 8.68819 -2.70507 8.56313 -439 1 9.34389 8.42481 3.82801 17.2784 -12.6228 -3.36469 -440 2 10.2481 8.71643 4.0808 -19.781 -0.493733 -4.13474 -441 2 9.39514 7.45876 3.71283 -1.01674 10.6173 4.41109 -442 1 17.6406 13.5721 16.5094 2.04355 14.6677 -13.2606 -443 2 16.6957 13.3564 16.5004 3.03121 5.86868 -4.35941 -444 2 17.7908 14.3862 15.9732 -9.46726 -16.3028 8.56732 -445 1 4.98477 10.3524 2.78056 12.7386 5.36526 19.5004 -446 2 5.77841 9.87677 3.08402 -8.11584 2.70387 -5.95057 -447 2 4.78102 10.9105 3.55814 -3.18863 -4.34789 -14.1468 -448 1 3.61985 8.409 9.90418 -6.90754 6.83907 7.996 -449 2 3.65115 9.35813 9.71914 3.08439 -3.40065 -3.71786 -450 2 3.2182 8.36489 10.7858 3.70965 -2.47637 -5.74153 -451 1 15.9601 6.9243 5.80742 5.84252 7.06727 3.15212 -452 2 16.6786 7.33659 6.3256 -10.6597 -9.43019 -8.8571 -453 2 16.2068 5.99858 5.66915 1.21675 5.97088 2.68601 -454 1 15.2845 7.30815 8.96614 12.789 49.367 -12.5087 -455 2 15.9618 7.62249 9.60336 -10.429 -10.3168 -7.48119 -456 2 15.189 8.09577 8.33246 -3.07462 -40.144 23.8491 -457 1 6.1828 12.7537 12.7561 7.28509 13.2747 4.63662 -458 2 7.05451 12.4627 13.0861 -13.4204 -0.208789 -0.140696 -459 2 5.95622 13.5898 13.2147 8.13015 -13.1574 -2.88232 -460 1 12.1263 4.55994 13.1396 29.7192 24.8274 2.05513 -461 2 12.1786 4.68706 14.0984 -0.0287765 -3.56256 -2.83377 -462 2 11.367 4.05454 12.9285 -29.3831 -17.3036 -0.987503 -463 1 11.4694 8.07241 7.80966 2.82892 -5.30182 3.11258 -464 2 12.1089 7.42736 7.43222 -7.16455 14.3649 9.80055 -465 2 11.7078 8.26067 8.74179 3.19872 -8.99269 -16.594 -466 1 16.9463 10.7531 7.60486 21.0922 -19.3927 -30.7185 -467 2 17.5464 10.0071 7.31859 -16.0594 21.8542 15.0855 -468 2 16.9098 11.3402 6.82058 -3.06841 -4.58473 14.7168 -469 1 5.28146 18.0409 10.6472 -25.9515 -7.83546 -6.26387 -470 2 4.85268 17.2439 11.0337 11.609 18.382 -10.1496 -471 2 4.62194 18.3715 9.98111 20.3861 -11.8767 18.8687 -472 1 7.65293 17.466 1.56177 -3.43219 -2.17163 16.4468 -473 2 8.27069 16.8213 1.23778 3.23069 -17.6415 -5.16563 -474 2 7.58305 18.0963 0.859771 -3.72786 20.9018 -9.77855 -475 1 1.92587 12.9087 13.6164 -8.16731 5.11551 18.4441 -476 2 1.30634 12.3949 14.1755 13.4846 7.44573 -7.00244 -477 2 2.13079 13.7319 14.1159 -1.95883 -16.9131 -9.84331 -478 1 9.29336 6.75339 14.7687 -19.1125 21.7104 1.76678 -479 2 9.711 5.9819 15.1082 15.9481 -24.452 8.13362 -480 2 9.58853 6.88119 13.8676 2.75751 0.822828 -8.36077 -481 1 15.2452 4.28737 10.7623 -0.225576 -4.08648 -1.74219 -482 2 16.1503 3.99339 10.8719 6.1947 -5.72264 -8.71474 -483 2 15.1717 4.92602 11.4736 -7.0877 3.5816 0.665059 -484 1 11.4391 6.24473 0.0517087 -15.4849 -28.4826 -7.88372 -485 2 11.5335 5.29025 18.4586 5.11122 21.8085 5.83846 -486 2 10.469 6.36117 18.7264 13.3105 4.99187 -1.92993 -487 1 18.4571 11.4845 14.9094 -8.14212 27.2991 -26.8701 -488 2 18.0442 12.0056 14.1458 10.7134 -26.1217 30.6713 -489 2 18.3691 12.0954 15.6567 -1.55188 -2.54901 -1.51407 -490 1 7.07006 9.2713 7.35429 3.52198 -23.4346 -4.90088 -491 2 6.57918 8.46088 7.59869 6.01934 15.522 -0.341791 -492 2 7.98054 8.95273 7.2441 -4.91945 6.78887 2.19469 -493 1 18.4213 15.3485 12.1512 14.6289 14.7183 -5.00343 -494 2 0.703338 15.6554 12.0361 -12.928 -5.55139 4.18882 -495 2 17.8805 15.9633 11.6295 -1.60931 -6.92771 2.64168 -496 1 16.5853 4.3259 5.32941 -3.23822 -14.2219 46.7572 -497 2 16.614 4.15863 6.32722 1.43031 7.89007 -40.0485 -498 2 17.5031 4.43236 5.0545 -4.12857 4.88068 -4.00684 -499 1 17.7656 3.15988 10.7489 -7.77815 -3.54726 5.22618 -500 2 18.6517 3.33727 11.1036 -6.02481 -6.41431 -8.69585 -501 2 17.7347 2.25304 10.4054 5.10772 5.83768 0.491016 -502 1 12.3532 18.6195 10.0845 2.26138 29.9542 0.82462 -503 2 11.4554 0.369133 10.2956 34.814 -7.7062 -6.49387 -504 2 13.0539 0.703372 10.1287 -31.4455 -25.8056 2.12568 -505 1 10.4062 9.7592 12.5463 4.94309 9.48659 9.1975 -506 2 11.1178 9.86775 13.2051 -4.84217 -3.21907 -8.75193 -507 2 10.4169 8.83 12.3092 -0.242296 -5.43122 1.67162 -508 1 0.754807 2.57366 7.2759 5.10959 9.37805 -1.17349 -509 2 1.15147 3.40426 7.59563 -2.53061 -11.14 3.70439 -510 2 0.94825 1.90755 7.95351 -0.370046 8.4477 -4.76995 -511 1 0.326852 15.3245 6.92393 7.78779 -47.7914 -15.9381 -512 2 0.478367 15.1955 7.87742 -3.54148 6.5065 -12.4551 -513 2 0.511792 14.4078 6.50445 -6.22026 47.2618 21.2659 -514 1 17.0448 6.87527 14.9011 7.50868 -3.64469 2.18783 -515 2 17.7829 7.50382 14.839 -4.82102 -5.02166 1.59119 -516 2 17.384 6.09018 15.3732 -3.19441 8.7454 -5.86774 -517 1 9.10521 12.4991 8.01627 -22.444 -7.37457 -9.07321 -518 2 9.5155 11.7197 7.59468 -6.97176 5.64777 -5.01838 -519 2 8.17012 12.5725 7.67989 31.3303 -7.17656 9.91942 -520 1 1.12679 1.65794 2.79756 -4.95635 8.46302 6.6874 -521 2 0.642552 2.15227 2.11219 8.6081 -1.07022 6.53976 -522 2 1.60228 2.28223 3.37541 -5.16033 -3.32404 -9.46208 -523 1 4.24509 15.0269 10.0531 -9.28044 4.63084 -2.70058 -524 2 3.93721 15.2031 9.15401 2.26907 2.00751 2.33164 -525 2 5.07496 14.5648 9.92961 6.13338 0.348707 3.17177 -526 1 7.39613 2.22212 14.8791 -10.1428 -2.73186 -2.62368 -527 2 7.12857 1.59843 14.1951 -0.211704 -1.85534 3.14611 -528 2 7.6308 3.01777 14.3992 6.19568 3.75469 -5.36272 -529 1 18.3005 14.5161 2.14907 5.30067 -9.26209 1.4902 -530 2 0.506128 14.8057 2.49377 4.6744 -0.083839 -4.04908 -531 2 17.8019 15.308 1.97101 -9.85855 11.1774 -0.48774 -532 1 10.0782 2.71092 12.8944 3.88974 -3.73664 -2.78909 -533 2 9.88925 2.05355 12.2072 4.3936 3.86452 2.74403 -534 2 9.31937 3.3006 12.9074 -3.94823 0.261307 -1.05017 -535 1 2.9306 8.79131 12.9512 -25.6961 -20.8645 -0.44372 -536 2 3.33593 9.62792 12.788 10.417 21.0465 -4.83397 -537 2 3.64632 8.1716 13.058 11.1871 -7.80414 6.67576 -538 1 3.17851 8.59155 3.78391 36.0219 9.48042 20.5594 -539 2 3.64638 9.17092 3.16182 -4.0064 -4.18597 2.27442 -540 2 3.67104 8.74964 4.63715 -24.9674 -6.25544 -24.3579 -541 1 5.79667 7.27872 8.61723 -5.158 -8.45889 2.36629 -542 2 5.76122 6.32524 8.453 -1.10357 3.40671 2.32671 -543 2 5.00318 7.4879 9.12925 4.38374 0.567505 0.838777 -544 1 14.9116 1.65307 1.84567 7.03031 -5.18946 -10.6018 -545 2 15.1062 2.45757 2.3139 -4.94852 6.93451 15.0643 -546 2 15.1691 1.84916 0.935056 -0.310542 -6.30296 3.0909 -547 1 8.67523 15.0369 0.613894 1.37845 1.1536 3.61737 -548 2 9.43682 15.0729 1.21213 -3.42809 -6.51916 3.89646 -549 2 8.00447 14.4711 1.03609 4.49017 7.63347 -1.72767 -550 1 15.3993 1.47022 7.19229 -20.8703 -2.58026 0.276614 -551 2 14.6837 0.967989 6.72584 19.4319 15.0033 11.4079 -552 2 14.9834 2.26826 7.5843 2.60239 -12.333 -11.18 -553 1 4.89704 12.855 18.4725 17.7474 3.66438 12.0852 -554 2 5.22521 13.0209 0.739851 -5.30909 -3.44768 -15.7686 -555 2 5.64886 13.1114 17.9131 -8.88833 1.88365 4.35483 -556 1 15.3966 8.71526 18.0579 -0.0737912 10.217 -6.92241 -557 2 15.7913 9.20885 17.3059 -4.72516 -6.1114 19.2356 -558 2 15.2466 9.35419 0.13361 -0.210218 -4.05252 -7.18588 -559 1 11.9654 3.16879 18.3684 -1.96391 -6.33771 9.57431 -560 2 11.8782 2.93896 0.667559 5.83177 -2.01678 -11.7343 -561 2 12.3624 2.38725 17.9444 -0.743858 8.0566 3.61175 -562 1 13.1976 12.733 5.19814 3.21154 2.81721 -3.88454 -563 2 13.6265 11.8743 5.11099 -2.80289 -1.59076 -2.45209 -564 2 13.3962 13.0406 6.08845 -1.48061 -3.43823 1.63358 -565 1 6.20234 7.07161 0.291392 8.37087 -8.50913 -15.2358 -566 2 6.21431 8.03007 18.9132 -3.08565 9.14852 3.50692 -567 2 5.28911 6.79756 0.384068 -8.05152 4.04277 7.5169 -568 1 17.755 15.8811 14.8809 -0.846783 4.67036 -1.95176 -569 2 16.8205 16.1356 14.922 6.46156 -5.25763 -8.70949 -570 2 17.9775 15.7319 13.9423 -7.01069 1.37948 9.8425 -571 1 13.0816 0.927432 16.7559 7.19813 -13.1533 1.9849 -572 2 14.0246 0.654652 16.7787 -14.5584 8.9122 1.46691 -573 2 12.5958 0.0867106 16.6751 4.09548 8.26383 -2.86333 -574 1 10.8721 14.5032 7.42074 17.8947 27.9436 -17.0444 -575 2 10.196 13.9242 7.71676 -22.829 -18.2345 11.9548 -576 2 11.6972 14.0514 7.58445 7.42519 -9.80791 -0.577526 -577 1 17.7647 8.42346 2.16939 -4.1598 1.60766 -5.89387 -578 2 16.8709 8.3975 2.49669 -12.234 5.23478 11.868 -579 2 17.7295 7.75318 1.48744 5.54579 -3.65645 -10.0136 -580 1 12.5773 7.79072 2.0332 1.0668 2.49746 -6.2566 -581 2 12.3914 8.73063 1.87761 -0.101344 -7.79782 -0.82295 -582 2 12.2276 7.2965 1.27263 1.31444 5.98607 5.5368 -583 1 12.0208 14.4615 10.4933 -27.7219 6.00234 -17.9899 -584 2 12.3406 14.2687 9.58404 -10.0812 4.98999 20.4987 -585 2 11.0483 14.7039 10.4238 33.6221 -8.97773 -1.58279 -586 1 6.69486 6.68845 15.5484 18.1135 9.98152 11.3143 -587 2 7.65688 6.85274 15.3559 -27.8703 -4.06425 5.81014 -588 2 6.48582 7.17335 16.3722 6.10572 -10.2019 -13.6564 -589 1 7.96659 4.39718 13.2272 4.51058 -7.9075 4.77481 -590 2 7.2893 4.70584 12.6248 -6.54048 3.46732 -4.14994 -591 2 8.21018 5.15068 13.7582 2.30488 10.1178 3.17748 -592 1 13.2671 12.2369 14.4347 -4.64765 -4.51239 1.04229 -593 2 13.0608 11.2949 14.304 4.07546 7.63325 0.952283 -594 2 13.624 12.5445 13.5893 -0.484314 -1.81518 4.66288 -595 1 14.4631 9.64208 7.37348 -3.22195 -17.9745 -8.46037 -596 2 15.2455 10.1455 7.54143 19.6931 12.3162 5.07411 -597 2 13.7594 10.075 7.84063 -11.2512 5.66435 9.63044 -598 1 12.6955 16.8004 3.38503 4.61351 40.5798 -15.2407 -599 2 12.79 17.4151 4.16128 -2.51333 -18.5745 -25.4999 -600 2 12.6728 17.373 2.55111 0.0132769 -17.6878 38.2975 -601 1 0.968812 6.96727 17.3326 -17.527 29.8281 -14.7856 -602 2 0.0966102 7.11435 17.7475 9.38145 -12.9539 -1.45746 -603 2 0.942675 7.56475 16.5473 6.51552 -11.7527 16.88 -604 1 12.9918 4.86088 15.7598 14.9884 1.53364 0.213735 -605 2 13.6417 4.12341 15.6561 -13.2544 27.5281 4.62454 -606 2 13.5036 5.69571 15.8607 -8.5455 -17.4296 -3.38108 -607 1 2.31456 3.41181 5.02375 -16.8072 14.5355 28.5245 -608 2 1.72499 3.01856 5.74541 26.0591 16.5367 -23.5498 -609 2 2.61813 4.33638 5.31016 -13.7452 -42.3935 -5.38282 -610 1 8.12877 10.8743 13.7813 26.8177 -26.1009 35.9685 -611 2 8.08888 10.4248 14.7095 5.12746 27.8083 -58.2879 -612 2 8.93477 10.511 13.3312 -19.2021 7.65314 13.0743 -613 1 13.0038 1.57226 13.2324 0.46489 2.31008 -10.6366 -614 2 13.6096 1.43937 12.4592 -18.9356 10.6634 16.2552 -615 2 12.412 2.34128 13.062 19.3329 -16.3736 -0.813643 -616 1 6.65189 13.7072 1.97939 -2.77776 -1.20266 13.9341 -617 2 6.01392 14.2112 2.53362 13.0928 -13.1372 -7.18637 -618 2 7.15166 13.1216 2.589 -8.8324 11.1791 -7.86511 -619 1 15.7768 6.33135 12.4394 -16.9523 -8.61752 -2.39927 -620 2 16.2545 6.83373 11.7966 11.5481 11.8457 -13.8092 -621 2 16.2346 6.49819 13.2509 8.584 1.06891 20.063 -622 1 16.7487 0.656157 9.53186 -1.89022 -32.3669 -10.6998 -623 2 16.6929 18.3191 9.69193 -1.14735 24.5709 0.588436 -624 2 16.3744 0.798362 8.64008 0.39513 1.76057 8.35052 -625 1 6.2256 11.6996 8.23382 -7.45249 -33.5883 4.29961 -626 2 5.41287 11.5766 8.79278 22.02 -5.73867 -21.2662 -627 2 6.53136 10.7979 7.88958 -15.1732 37.063 20.6987 -628 1 2.75779 8.608 0.340468 -48.3199 -4.33351 -7.97969 -629 2 2.08546 8.0585 18.4464 30.1073 27.602 24.3697 -630 2 2.23564 9.25518 0.892435 12.8354 -18.7139 -20.5564 -631 1 10.0773 10.2182 6.62419 2.67327 1.92209 4.62159 -632 2 10.5668 9.53044 7.10449 -1.07652 4.95909 -5.68289 -633 2 10.5655 10.3766 5.79827 -6.62323 -4.53969 7.46345 -634 1 6.84859 15.7294 6.8116 4.5172 -4.61086 -5.81045 -635 2 7.14728 16.2498 7.57791 -4.63192 -2.64256 -11.095 -636 2 7.17659 16.1616 6.00258 -4.95191 3.23702 9.76552 -637 1 6.62071 12.9207 5.93401 2.33655 2.8557 1.84805 -638 2 6.83452 13.8255 6.17261 -0.629609 6.79635 0.913528 -639 2 6.25462 12.5309 6.73716 -1.14115 0.401949 -5.14594 -640 1 16.7089 12.5339 9.77339 -0.869689 -1.39856 -8.71911 -641 2 16.7622 11.7819 9.15626 3.31473 10.0385 4.47785 -642 2 17.1611 13.2788 9.34464 -3.7572 -10.2702 6.17681 -643 1 6.29845 2.79213 2.75928 -3.20566 -14.4941 8.67087 -644 2 6.41489 3.68807 2.47435 5.42045 18.7619 -3.24562 -645 2 5.94058 2.32523 2.00482 -4.41542 -3.11109 -6.82659 -646 1 10.6289 2.95834 3.25769 -6.57134 8.8614 -3.08687 -647 2 10.3824 3.87829 3.42309 -0.834706 -5.50201 2.33367 -648 2 10.1446 2.71475 2.45701 2.51779 -3.35726 0.152255 diff --git a/examples/amoeba/dump.water_box.hippo.32.test b/examples/amoeba/dump.water_box.hippo.32.test deleted file mode 100644 index 33463a3a5d..0000000000 --- a/examples/amoeba/dump.water_box.hippo.32.test +++ /dev/null @@ -1,7227 +0,0 @@ -ITEM: TIMESTEP -0 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.67966 7.08769 17.9461 -19.3527 -13.639 6.25201 -2 2 7.80945 6.75579 18.2607 18.4949 11.1596 -6.01922 -3 2 8.72223 6.81424 17.0254 5.85599 -0.890166 3.45586 -4 1 18.5257 8.24445 6.83762 11.8085 12.5587 58.8481 -5 2 0.216892 7.89544 6.05003 10.8935 -14.9684 -50.5046 -6 2 0.444268 7.82601 7.5302 -15.2958 7.9793 -8.89884 -7 1 8.37906 18.5504 6.81463 25.5385 6.64228 -3.75624 -8 2 9.34042 0.098069 6.73406 -20.9151 -2.68951 1.38711 -9 2 7.93962 0.573676 6.26984 -0.656308 -0.308718 3.40946 -10 1 6.58995 1.84432 11.7198 46.6828 -15.9611 -12.5859 -11 2 5.88543 2.40231 11.9251 -37.6261 28.8114 18.1934 -12 2 6.18153 1.06275 11.3693 -6.58868 -16.6156 -5.55691 -13 1 7.1466 5.75358 2.33152 -56.1364 42.5085 -2.61462 -14 2 6.36812 6.12603 2.86268 40.1937 -23.4301 -4.21826 -15 2 7.02502 6.29465 1.5182 16.3021 -20.7884 10.9258 -16 1 16.2164 10.1388 16.1382 -32.0875 21.5958 16.7579 -17 2 16.9509 10.2747 15.5847 32.9015 -1.03241 -20.1636 -18 2 15.8498 11.0405 16.2399 1.98783 -14.756 2.71439 -19 1 10.6046 15.0374 2.30369 -8.13409 -25.494 -7.18668 -20 2 10.5292 14.3949 3.01849 1.41683 -0.603724 2.75561 -21 2 11.0236 15.78 2.70962 11.6057 19.8833 4.5888 -22 1 17.1624 8.24409 10.3708 13.0676 7.07862 9.73504 -23 2 16.5528 8.68798 10.966 -4.65968 7.37974 1.83434 -24 2 17.9421 8.82333 10.3208 -6.34155 -10.1937 -2.20396 -25 1 14.901 15.8652 16.3167 18.01 -6.87509 18.5636 -26 2 14.0225 16.1982 16.2525 -26.9236 12.7201 -6.50875 -27 2 14.9141 15.482 17.2099 2.63751 -6.05913 -7.59706 -28 1 12.1752 13.3771 0.408263 -11.3168 6.26442 9.98381 -29 2 12.0579 13.8465 18.23 5.67057 -4.50268 -16.0578 -30 2 11.6217 13.8904 1.00796 3.42507 -1.00312 9.73088 -31 1 9.27358 5.34243 4.05546 -35.2781 32.5984 16.8393 -32 2 8.64594 5.4665 4.83764 28.3783 -16.8163 -28.778 -33 2 8.74177 5.68615 3.30282 7.52493 -14.9247 9.48156 -34 1 1.83016 4.27673 11.6495 -21.1764 37.5598 -8.14901 -35 2 1.70328 5.22377 11.9391 6.02814 -28.7768 -8.29565 -36 2 2.40811 3.85345 12.2597 13.4728 -11.3181 18.3421 -37 1 1.96438 6.83299 8.3731 -11.1902 3.43717 -25.3738 -38 2 2.49614 7.21578 9.0563 9.35281 -0.190165 18.6039 -39 2 1.81128 5.90585 8.57354 7.84101 -3.79534 5.21373 -40 1 5.40557 4.38899 7.93274 -6.81526 4.7224 -2.63907 -41 2 5.53738 3.43895 7.78131 -7.79962 9.88898 0.533881 -42 2 4.75516 4.73491 7.29062 10.7858 -16.238 7.24535 -43 1 3.23 2.92842 17.5524 -0.538114 20.9936 16.7312 -44 2 3.93109 3.19827 16.9402 -0.965509 8.21721 4.01649 -45 2 3.00444 3.70897 18.1497 6.13449 -29.114 -23.6081 -46 1 7.4624 5.26283 6.13117 9.12728 4.25284 -1.73168 -47 2 8.02565 5.58849 6.88177 -24.817 -14.4341 -14.6054 -48 2 6.93508 4.45577 6.3254 16.0496 22.0303 12.0173 -49 1 9.77896 7.02384 11.9834 11.1205 -3.87253 23.9446 -50 2 10.2721 6.37256 11.5011 10.9222 -10.0302 -1.39678 -51 2 9.1532 7.31587 11.3499 -23.6433 13.1239 -20.7784 -52 1 14.1167 3.54999 8.03003 -30.7601 -1.60704 -37.9113 -53 2 13.4732 4.22413 7.73132 15.1608 -10.723 4.30178 -54 2 14.3809 3.80189 8.88487 12.8065 16.1495 34.678 -55 1 4.82329 17.2568 4.03846 -17.85 32.0436 -31.4073 -56 2 5.49315 17.973 4.01308 -7.71314 -24.6342 10.4391 -57 2 4.18746 17.5412 3.33843 10.9703 -13.5421 12.8553 -58 1 16.4918 16.6259 10.0493 29.9016 15.3745 -40.7533 -59 2 16.1673 16.3226 10.8594 -24.6786 -13.0437 37.8908 -60 2 15.9925 16.2084 9.33562 -4.01544 -1.82242 7.63759 -61 1 1.94489 4.93323 0.49791 29.1886 10.4759 3.59715 -62 2 2.55322 5.26335 1.2053 -17.2324 -10.4098 -15.9422 -63 2 2.08253 5.591 18.4408 -14.7087 -3.80383 3.81857 -64 1 11.816 13.3571 16.2711 -7.8083 1.12937 6.2001 -65 2 11.2371 12.6203 16.5671 13.3708 1.96491 -16.2063 -66 2 12.2446 13.1893 15.4079 -11.197 -7.32732 11.8633 -67 1 10.105 11.0651 16.9545 16.7158 -32.7784 1.37979 -68 2 10.5674 10.1947 17.1295 -14.0823 30.097 -5.45833 -69 2 9.25349 10.8067 16.5912 -2.99511 2.11526 2.57572 -70 1 11.7264 17.5421 13.4742 2.50122 -25.0158 -11.214 -71 2 12.2771 16.9836 12.8968 -8.91486 0.79877 6.23222 -72 2 12.1041 18.3936 13.317 1.59091 22.4782 2.42571 -73 1 6.33029 9.31911 12.2264 15.6898 -25.4439 -25.1534 -74 2 7.02603 8.96242 11.6353 -17.823 2.07037 1.33758 -75 2 6.81249 9.95941 12.7172 5.93051 22.1649 19.4162 -76 1 16.2187 12.7249 2.70186 -8.69715 -37.3569 7.82337 -77 2 17.0292 13.1566 2.50302 19.6243 18.7999 -9.68795 -78 2 15.4982 13.3357 2.61812 -8.61102 21.6356 1.57727 -79 1 0.637202 12.5625 5.84914 -32.6687 7.10288 -2.13707 -80 2 0.892312 12.5507 4.90771 -4.51242 -1.40786 13.4578 -81 2 18.3039 12.804 5.85329 37.5994 -4.88925 -6.97833 -82 1 5.19922 16.3781 18.5047 -7.71264 -0.634541 -12.9921 -83 2 5.80284 15.8543 17.9455 2.11468 10.7978 13.7187 -84 2 5.67034 16.9636 0.462296 7.23142 -5.58048 -3.24093 -85 1 0.510145 7.62945 4.0545 45.851 19.5686 -25.4796 -86 2 18.5719 8.14656 3.45296 9.61971 -16.7838 10.3831 -87 2 1.46496 7.74082 3.66917 -52.3954 -1.94356 25.3273 -88 1 3.14672 8.89584 6.52626 -54.2957 5.34018 -1.73828 -89 2 3.50609 8.59991 7.35294 9.18701 -2.26398 8.55435 -90 2 2.14573 8.92962 6.68203 45.3688 -0.563656 -9.64228 -91 1 7.30854 10.3037 16.1717 -0.0267506 0.140778 15.7468 -92 2 6.56213 10.4624 15.5802 1.32412 -0.384411 10.7132 -93 2 6.99303 10.278 17.1118 0.130505 3.94788 -23.0495 -94 1 11.1122 1.06968 4.98939 -2.83136 -16.8604 13.0177 -95 2 11.0776 1.97142 4.64864 2.2702 -4.31387 -11.6367 -96 2 10.7048 0.433547 4.37027 2.96408 14.9419 -2.56144 -97 1 4.45204 2.70061 13.2052 -8.32298 -31.9478 35.5434 -98 2 4.60333 3.05865 14.0914 -0.476624 15.5497 -15.2927 -99 2 4.38645 1.737 13.4626 0.207127 24.1129 -25.2696 -100 1 8.42792 10.0237 1.78469 -10.6267 -17.9408 16.848 -101 2 8.3405 10.6377 2.53622 4.43246 -2.98222 -4.40025 -102 2 8.49672 9.11244 2.17467 4.60711 29.3182 -9.45134 -103 1 10.5335 1.75383 15.546 -31.9958 -1.22726 0.532554 -104 2 11.3977 1.82718 15.9216 23.4057 -5.242 -0.0927752 -105 2 10.5608 1.78317 14.5837 3.34522 3.38855 0.282019 -106 1 2.77693 12.941 7.74821 -10.6415 2.34425 -2.27994 -107 2 3.28797 13.5733 7.23382 5.58977 0.334345 4.09149 -108 2 1.98704 12.8256 7.20013 5.22386 -8.52712 2.54059 -109 1 3.63517 11.6895 5.33963 -10.2259 -13.0028 -10.3717 -110 2 3.35385 11.0502 6.03137 4.73753 15.317 -16.6328 -111 2 2.8758 11.855 4.74058 11.3048 -4.09559 12.5928 -112 1 6.88803 14.474 16.8428 -13.42 9.46677 6.94107 -113 2 7.55973 13.8293 16.6383 4.5229 -1.76969 -1.40507 -114 2 6.60381 14.8838 16.0165 0.0834179 -9.06129 -0.120708 -115 1 14.1722 14.5374 3.41536 20.1951 -3.19134 -21.8839 -116 2 13.6514 15.2845 3.14096 -9.23852 13.3738 0.77613 -117 2 13.8512 14.2508 4.25439 -13.5451 -9.47926 16.7085 -118 1 8.28226 18.1809 16.0824 -9.43856 -15.6135 -5.07226 -119 2 8.77677 17.3494 16.3071 1.43839 31.5077 -5.33478 -120 2 8.7603 0.384816 15.9919 11.1327 -19.5096 4.24776 -121 1 4.73724 1.61643 4.90111 5.86874 37.6921 -30.6753 -122 2 3.96969 2.16837 5.15263 9.12039 -10.9712 -6.28456 -123 2 5.18465 2.1484 4.15475 -17.6049 -26.8232 41.7187 -124 1 15.1457 12.8616 16.4403 -17.0638 -11.2899 43.408 -125 2 14.6041 12.8692 17.2613 22.7365 8.03356 -12.6578 -126 2 14.49 12.6307 15.8136 -17.0236 -4.89604 -35.7974 -127 1 15.779 18.3837 16.786 48.5063 8.0766 44.3104 -128 2 16.5108 18.615 17.4688 -41.9285 -7.99937 -34.0327 -129 2 15.7694 17.4186 16.7687 -10.3466 2.2793 -1.1406 -130 1 1.1383 1.1331 16.5571 -3.54071 10.9478 5.94974 -131 2 1.96551 1.50352 16.9177 -15.9767 0.55296 -3.51275 -132 2 0.420521 1.53444 17.0916 21.5279 -7.8795 -5.43288 -133 1 18.0817 4.5907 15.863 15.8138 -19.1991 -2.64562 -134 2 18.5818 3.91936 15.3489 -11.6552 16.5822 9.8521 -135 2 18.5602 4.7339 16.6874 -1.16116 -1.56098 -3.02727 -136 1 12.22 16.9378 16.1148 -9.97587 -12.4224 57.0196 -137 2 11.409 16.6934 16.6676 29.0172 6.05041 -31.7989 -138 2 11.9646 17.3216 15.2917 -14.4882 2.9648 -22.1743 -139 1 15.8709 2.55221 17.9707 -3.56258 26.452 -16.7944 -140 2 15.7355 3.48355 18.2574 6.35046 -25.5765 3.86241 -141 2 15.6659 2.59235 17.0072 6.0189 -6.56803 19.8103 -142 1 6.70868 13.791 10.2637 1.94011 22.9489 3.02058 -143 2 6.59347 13.548 11.1958 0.710608 -4.45224 -7.92394 -144 2 6.58252 13.0514 9.6765 -3.73143 -16.591 0.344408 -145 1 10.146 18.2027 2.80372 16.894 35.9 -12.6825 -146 2 10.2207 0.331961 2.18345 -1.03174 -23.6422 14.9845 -147 2 9.26571 17.8868 2.67703 -18.7462 -7.34721 -7.1199 -148 1 2.97538 17.748 6.06078 -27.2244 1.77787 1.96995 -149 2 2.09399 17.6473 5.67013 1.23544 -3.46851 16.5241 -150 2 3.45883 17.8838 5.26396 32.1509 0.10025 -8.47089 -151 1 12.558 17.0134 7.97028 2.72879 -14.1128 -3.91884 -152 2 11.9572 16.2512 7.82085 4.20569 13.3061 15.6125 -153 2 12.4657 17.4524 8.83591 -10.4039 -6.95813 -9.08653 -154 1 14.8795 15.2862 8.28544 5.56082 -19.5077 38.9848 -155 2 13.9824 15.6136 8.40666 -1.04882 8.68143 -14.5015 -156 2 15.2312 15.4641 7.43118 2.2507 10.8701 -29.8329 -157 1 17.5429 18.3228 0.375372 -51.3852 -2.4253 -14.1847 -158 2 18.116 17.6308 0.128652 38.5367 -21.5025 -8.63787 -159 2 17.9698 0.288559 0.934677 24.3068 21.4661 19.9837 -160 1 0.910209 10.3712 1.41143 -2.71779 -52.992 43.3073 -161 2 0.158544 9.88347 1.87089 22.0109 19.7614 -26.7074 -162 2 0.565924 11.0969 0.944383 -22.7833 34.6337 -23.5778 -163 1 1.55407 12.175 3.31087 16.6578 22.9783 50.8488 -164 2 1.36245 11.4802 2.72234 -7.70692 -21.3552 -33.2695 -165 2 1.61623 13.0206 2.87285 -0.913798 3.83337 -14.7861 -166 1 0.543127 17.2543 4.88609 29.8094 34.6465 -52.7559 -167 2 0.11032 17.9772 5.31124 -19.8915 12.2203 12.8491 -168 2 0.420366 16.4266 5.2673 -10.0988 -43.8479 36.8786 -169 1 1.10053 1.01949 9.38768 20.7334 -4.84081 3.89797 -170 2 1.46081 0.575286 10.1589 7.03147 5.77442 11.7732 -171 2 0.265613 0.594128 9.34525 -29.6063 -3.3853 -10.3011 -172 1 16.8007 2.32783 13.2877 6.1037 15.2386 -31.0559 -173 2 17.0701 2.57314 12.3549 -10.0746 -10.076 30.4228 -174 2 16.4263 1.43993 13.282 1.60122 -3.62923 0.222317 -175 1 2.45231 15.8283 12.1942 27.8718 -10.8871 18.2649 -176 2 2.8623 15.5513 13.0537 -9.1784 7.03247 -27.4702 -177 2 2.91392 15.3801 11.4615 -3.34054 6.42182 7.24567 -178 1 16.435 15.531 5.9458 21.7194 38.3058 -21.2998 -179 2 17.3808 15.5177 6.20547 -16.0791 -6.59953 3.69269 -180 2 16.4147 16.2211 5.22063 -10.9707 -19.0563 26.084 -181 1 5.84547 5.02056 11.8065 15.5941 -20.7973 -13.2046 -182 2 5.55799 5.91374 11.8891 -11.5246 18.633 11.9833 -183 2 5.09 4.45915 11.9819 -3.94875 -1.81326 3.16792 -184 1 15.2214 4.86555 0.731755 -13.7826 -16.8748 28.0949 -185 2 14.6776 4.45845 1.47821 23.1081 18.7106 -26.9415 -186 2 14.6696 4.95834 18.5986 -11.4435 4.17379 2.92627 -187 1 16.3401 16.2933 2.11217 18.5695 -12.4905 -31.3072 -188 2 16.0666 16.7695 2.87319 -12.4192 21.1701 22.1863 -189 2 16.7601 16.9279 1.50378 -10.9162 -1.12869 10.7347 -190 1 0.305885 4.87877 3.79118 -7.51195 53.5881 20.4451 -191 2 0.299338 5.85541 4.09758 -3.10789 -46.5114 -24.0825 -192 2 1.16991 4.5635 4.03062 6.84312 -11.1831 1.05233 -193 1 2.92501 14.9782 15.0356 -4.41813 7.08234 41.1019 -194 2 3.0159 14.7264 15.9987 0.986861 -4.57119 -32.7424 -195 2 2.35392 15.7535 15.1247 6.41577 5.11218 -9.25191 -196 1 1.1115 14.5727 9.55731 53.3594 20.601 -11.7192 -197 2 2.08491 14.4157 9.46275 -24.0912 20.2308 -9.17401 -198 2 0.897072 13.7408 9.90248 -29.0631 -35.5955 19.1061 -199 1 13.6501 16.6688 11.5433 6.78983 17.7214 -9.74398 -200 2 13.4697 17.4567 10.9694 -2.9322 -22.903 16.7504 -201 2 13.5721 15.8897 10.9842 -10.359 0.342192 0.0202177 -202 1 4.73098 1.47842 0.720986 -5.29759 -7.25447 0.0447572 -203 2 4.27169 1.98826 0.034225 -5.56193 -3.14325 9.7343 -204 2 4.11741 0.788607 1.06182 6.25861 16.2271 -3.37713 -205 1 1.42158 18.4663 11.9139 -14.0127 27.0043 -17.9914 -206 2 1.21766 0.394331 12.6648 1.7087 -1.58128 0.41261 -207 2 1.94844 17.765 12.2423 13.0376 -22.9613 11.2697 -208 1 11.5498 10.1018 4.11619 27.4262 20.5676 -21.0421 -209 2 11.5687 10.5955 3.24216 -3.20948 -18.7647 28.9446 -210 2 12.4899 10.1059 4.45555 -29.515 -1.53007 -14.7279 -211 1 8.38254 12.182 3.76573 -26.3924 1.04105 6.81072 -212 2 9.25863 12.501 4.06076 -19.5654 3.48754 6.33549 -213 2 7.63736 12.4251 4.40785 41.4561 -5.4387 -17.0092 -214 1 14.3228 4.03714 3.29709 11.5996 0.889358 18.0886 -215 2 14.8928 4.14179 4.10547 -12.6664 -0.432988 -23.901 -216 2 13.4701 4.45558 3.48891 5.46089 -2.24129 3.2962 -217 1 5.58188 1.78199 7.50513 -33.666 -46.5708 42.0626 -218 2 5.0172 1.13958 8.12095 34.1345 40.5367 -42.64 -219 2 5.33078 1.59122 6.59529 1.4651 -1.13721 -3.53311 -220 1 17.9086 1.12503 4.88467 5.13037 -2.27617 -10.7476 -221 2 18.4038 1.54032 4.14207 -7.55128 -2.38968 19.1857 -222 2 17.6814 1.78344 5.55455 5.62983 -0.00428508 -6.93418 -223 1 6.83101 9.39303 4.49716 -12.9019 3.06885 -29.4929 -224 2 6.83675 9.57499 5.42715 5.2276 -1.57178 18.8103 -225 2 7.66807 8.99049 4.24996 8.60683 3.06936 7.19189 -226 1 2.71406 14.9654 1.962 -12.6433 -7.2797 -26.4735 -227 2 3.33343 14.7912 2.66354 11.3685 -5.36414 4.18623 -228 2 3.09502 14.6645 1.10257 -3.50464 10.9487 24.1748 -229 1 17.279 12.8803 13.1283 -18.5839 20.1434 9.0108 -230 2 16.4044 13.2339 13.3283 -9.51346 -21.2442 0.20606 -231 2 17.6948 13.7346 13.0834 29.6252 3.29486 -10.2855 -232 1 15.0196 10.5818 1.38314 -38.8036 -34.5801 -31.952 -233 2 15.5102 11.1963 1.85791 33.5109 39.8843 28.1173 -234 2 14.3351 11.0964 0.933298 4.14202 -6.46403 5.49191 -235 1 5.71789 6.95838 4.52856 4.11089 -29.6335 9.96606 -236 2 5.85266 7.87985 4.34179 3.17266 16.1428 1.23553 -237 2 6.44364 6.70841 5.13514 -12.5329 -0.461157 -7.94794 -238 1 8.12142 8.26262 10.159 -0.855146 6.49391 46.4818 -239 2 8.58519 8.93965 9.66877 4.4396 1.59282 -10.2318 -240 2 7.56021 7.74854 9.59836 -7.32825 -5.6782 -22.3885 -241 1 13.5311 18.2901 5.8079 -14.4364 -13.815 12.5854 -242 2 12.703 0.102298 5.56963 8.23181 2.14052 6.61043 -243 2 13.2939 17.6289 6.50758 2.60691 23.7973 -17.1373 -244 1 0.327324 2.56344 0.113251 2.62118 15.3541 1.11187 -245 2 18.009 2.52214 18.5736 10.3638 17.1812 4.70476 -246 2 0.724331 3.48299 0.160564 -23.8753 -26.7718 -0.881277 -247 1 12.6396 10.9599 9.76875 -60.0152 14.8867 -10.4701 -248 2 11.6552 10.7306 9.75031 40.0232 26.8927 -4.84212 -249 2 12.944 10.1383 10.0842 28.9404 -31.8014 10.6031 -250 1 0.789377 12.2851 11.08 12.3121 4.77193 16.7259 -251 2 18.4919 12.3017 11.2021 -18.2956 -1.72231 -7.06107 -252 2 1.09088 12.7637 11.8722 5.11265 -11.1183 -7.6011 -253 1 5.04567 7.2193 13.4912 -20.9717 -2.87687 -14.2941 -254 2 5.59899 7.84649 13.0247 8.94565 11.9067 4.64647 -255 2 5.48047 6.97898 14.3058 11.2978 1.34955 6.76892 -256 1 1.28609 6.99027 11.837 -50.3798 -70.0072 -12.7986 -257 2 0.481329 7.14037 11.2978 16.1889 0.462756 10.6855 -258 2 1.71601 7.79102 11.8803 28.8555 60.7949 7.07409 -259 1 15.4442 9.46712 12.3088 17.5488 35.5581 30.8368 -260 2 15.6103 10.4448 12.4444 -11.4156 -32.7422 -13.7105 -261 2 15.5582 9.10301 13.208 -6.0251 -0.167312 -17.6616 -262 1 16.6404 12.9744 5.44078 -0.477448 -16.7093 5.71929 -263 2 16.2955 13.8866 5.54247 6.71099 -18.3284 -17.4666 -264 2 16.51 12.593 4.54035 -5.5475 22.5864 15.6708 -265 1 6.17495 10.0683 0.210584 -22.0037 -7.52033 -29.8636 -266 2 5.35839 10.4511 0.557392 5.20282 -1.85407 -1.83494 -267 2 6.76092 10.0813 0.943985 23.8798 0.550264 15.5383 -268 1 12.3644 6.05734 4.04236 -20.6788 -35.4367 28.6454 -269 2 12.4738 6.70802 3.38308 -3.94744 31.282 -24.9442 -270 2 11.4212 5.77124 4.03221 20.7152 8.11174 -1.23853 -271 1 0.124733 12.8266 0.203961 1.72956 2.54106 -4.3392 -272 2 0.029974 13.5935 0.786871 -3.06107 -4.47794 0.0529132 -273 2 18.185 12.9963 18.0877 7.84157 1.57112 5.96497 -274 1 3.83931 18.5785 8.61972 17.9182 -8.56599 -14.1766 -275 2 3.58625 18.36 7.70531 -6.70328 -0.941099 8.10721 -276 2 3.07994 0.282626 9.06556 -18.5101 7.20519 -0.527908 -277 1 7.37599 17.2741 4.45241 45.8101 34.7343 -2.7797 -278 2 8.02493 17.9603 4.76808 -26.0663 -25.3607 -1.65849 -279 2 7.47725 17.3636 3.49301 -12.8678 -9.31687 6.18264 -280 1 9.20909 17.0315 12.2197 44.1268 -5.71549 17.0535 -281 2 9.48765 16.172 11.8421 -16.3435 15.6721 -2.29993 -282 2 9.99892 17.2887 12.7762 -25.7988 -5.61825 -13.0657 -283 1 13.3284 13.0292 7.94175 -52.6762 -33.6944 -6.73328 -284 2 13.0533 12.253 8.47808 14.3801 9.17086 -2.06391 -285 2 14.1985 13.2855 8.14946 32.3912 12.3835 13.183 -286 1 14.9871 2.94126 15.3478 14.7752 10.8142 -9.8874 -287 2 14.2243 2.52816 14.9303 6.27209 -7.10728 -1.53608 -288 2 15.7054 3.02501 14.6718 -21.9622 -5.02255 13.6584 -289 1 9.85637 15.4939 17.0026 6.25802 5.34328 -5.30261 -290 2 10.2013 14.6312 16.7411 3.93948 4.67059 -1.18803 -291 2 9.35728 15.3668 17.8085 -8.94372 -2.90673 5.88613 -292 1 11.2848 8.23994 16.5492 3.15289 33.2939 2.2253 -293 2 10.8315 7.75123 15.8747 -9.91387 -14.5897 -7.3255 -294 2 11.7506 7.62533 17.1016 4.32393 -13.5731 6.91104 -295 1 3.77097 18.1898 16.7118 5.96936 32.6304 11.943 -296 2 4.24576 17.6768 17.3569 8.77088 -19.0197 5.38959 -297 2 3.7978 0.441972 17.1008 -3.8528 -14.6362 -12.0582 -298 1 2.20581 4.09889 8.95874 4.57905 1.19328 9.26631 -299 2 3.00197 3.55544 8.74643 -17.2537 17.4622 14.7611 -300 2 2.10364 4.24367 9.94001 11.4926 -15.28 -28.3391 -301 1 9.9196 10.3581 9.75231 -27.966 16.15 -17.0738 -302 2 9.34403 11.1055 9.40387 24.0849 -21.7639 18.0289 -303 2 9.87032 10.282 10.7171 1.16507 9.52838 -7.01624 -304 1 9.73405 0.807167 10.8572 18.2139 21.6835 4.91261 -305 2 9.58177 18.5811 11.2204 -14.9491 -12.8069 -2.84973 -306 2 9.10878 1.03014 10.1675 -9.37034 -6.01821 -3.77915 -307 1 9.18221 15.2247 10.2123 -19.1642 -10.2407 -19.6365 -308 2 9.04674 16.0847 9.7631 0.663926 -17.4388 12.4081 -309 2 8.3908 14.6843 9.94105 22.9839 14.6501 17.4764 -310 1 1.00316 9.27987 10.329 14.3691 -27.2472 -11.0896 -311 2 1.16727 10.1904 10.5724 12.779 8.1681 -2.56256 -312 2 1.84996 8.76119 10.1498 -30.7163 35.51 10.5854 -313 1 16.8004 4.89338 8.19813 23.5039 -12.6505 29.7165 -314 2 16.1748 5.31624 8.83318 15.8467 -9.35353 -17.5774 -315 2 17.4877 4.38941 8.71628 -29.2517 16.802 -13.3541 -316 1 14.6379 14.6893 0.402347 -11.159 -0.978579 14.7724 -317 2 14.9609 15.3376 1.05877 0.0769081 -12.0935 -6.53519 -318 2 13.9048 14.1906 0.841144 15.9383 15.9909 -14.4014 -319 1 3.51181 11.0525 9.63829 2.1739 12.5105 -11.7746 -320 2 3.41507 11.3617 10.5484 4.86707 2.92948 -3.5212 -321 2 3.25155 11.8076 9.06383 -0.0479228 -15.275 7.06779 -322 1 11.0289 10.8695 1.26208 17.169 21.0662 -6.34954 -323 2 11.1535 11.716 0.753779 -4.03889 -27.9068 14.1765 -324 2 10.1142 10.5923 1.16471 -3.02205 2.54599 -1.38039 -325 1 13.2239 7.06188 12.8977 -30.3793 3.52384 -4.06516 -326 2 14.1381 6.84046 12.8922 25.6531 -5.59605 1.27225 -327 2 12.7471 6.22139 12.9668 3.13335 6.34025 -4.15647 -328 1 9.62584 1.88878 0.937813 20.0839 -1.09549 37.2578 -329 2 8.77484 2.11506 0.623903 -26.2152 1.3675 -15.013 -330 2 10.1764 1.70882 0.191067 9.10224 -0.512606 -16.4895 -331 1 10.6054 13.537 4.7508 -3.45661 -5.20977 -1.23778 -332 2 11.3208 12.9359 5.04367 -5.78837 16.6981 -6.98771 -333 2 10.4128 14.1619 5.47507 11.2154 -13.4565 -5.70688 -334 1 14.2525 1.6915 10.8868 25.1006 21.2848 4.13062 -335 2 15.0842 1.26497 10.6465 -4.75627 -8.22365 -3.1417 -336 2 14.5069 2.62992 10.8824 -13.5101 -4.08816 2.36647 -337 1 14.6678 12.4248 11.7157 -12.7858 -12.3306 -9.5252 -338 2 15.5574 12.5766 11.3177 -24.032 -11.5318 -4.29299 -339 2 14.0022 11.9667 11.1187 32.4402 16.632 10.9337 -340 1 8.24065 5.08218 9.78509 -7.81525 41.6802 29.5679 -341 2 7.45364 5.10173 10.3836 16.236 -11.1581 -20.3292 -342 2 8.36822 4.22882 9.41503 -10.4798 -31.0118 -7.50393 -343 1 1.59893 16.8132 18.3262 1.78713 43.6046 -19.4726 -344 2 1.99225 17.1675 17.4932 -13.4068 -2.95443 18.1753 -345 2 1.72693 15.8931 18.2458 9.12037 -33.6792 3.80865 -346 1 1.43382 17.2563 15.3383 70.3372 -10.1908 -13.5082 -347 2 1.32309 18.1562 15.5759 -5.39176 26.6374 11.2222 -348 2 0.623143 16.841 15.3782 -64.6751 -20.2725 0.847241 -349 1 3.73599 5.55499 6.2196 -13.8181 39.8005 -2.84681 -350 2 3.32092 6.26594 6.76194 2.21889 -20.7758 -8.723 -351 2 4.19567 6.05321 5.52665 5.67395 -4.434 2.61268 -352 1 12.357 9.41487 14.1826 15.3987 -29.3966 1.09302 -353 2 12.9591 8.63784 13.9021 -33.8501 34.209 16.2235 -354 2 11.936 9.15457 15.0346 16.6427 1.77305 -15.4117 -355 1 4.0362 15.2647 6.90572 33.8672 24.728 -7.08093 -356 2 3.45744 16.0249 6.7945 -6.17655 -1.99751 -5.28974 -357 2 4.92941 15.6518 6.66696 -29.006 -22.9584 9.78444 -358 1 0.606517 8.56128 14.8606 9.39684 15.8059 -8.30397 -359 2 0.498099 9.52604 14.9437 -1.87135 -9.61679 5.58044 -360 2 1.28855 8.50016 14.167 -9.83185 -6.21013 7.33103 -361 1 12.9763 8.3683 10.3434 1.19405 4.03237 -29.9304 -362 2 13.7163 7.90436 9.89822 -7.22584 1.47622 17.5396 -363 2 12.9003 8.0957 11.2534 8.23718 -11.529 10.7869 -364 1 15.2983 7.63672 3.47583 -36.323 -26.5913 31.5529 -365 2 14.5024 7.10501 3.29647 15.7237 15.5958 -25.1442 -366 2 15.2922 7.47095 4.43335 26.8259 14.207 -3.84044 -367 1 17.3208 6.63818 0.028906 -16.9884 17.5938 -6.80353 -368 2 16.7479 6.05403 0.554933 4.15554 3.30118 -7.73843 -369 2 16.7141 7.27151 18.2009 11.1968 -20.2911 18.275 -370 1 8.79355 6.92545 7.84172 -17.9944 -26.8715 17.7017 -371 2 9.63968 7.32585 7.85068 34.0918 14.4557 -5.0304 -372 2 8.77688 6.39871 8.67404 -5.99252 8.25367 -18.4431 -373 1 12.3209 0.607808 1.1741 -9.70621 -1.67076 -6.18378 -374 2 12.995 1.15082 1.58835 11.8921 -6.95349 3.94176 -375 2 12.79 18.5825 0.66073 -1.23695 5.23567 5.50046 -376 1 5.68514 15.097 14.5145 3.67475 30.0662 -16.0184 -377 2 4.72797 15.1695 14.4772 -3.92865 -1.97247 7.85561 -378 2 6.02476 15.8935 14.032 -4.97132 -21.5573 17.6103 -379 1 3.822 6.53853 1.67803 9.4136 -3.73603 -11.0507 -380 2 3.54968 7.33117 1.17576 -2.2757 -10.4776 17.1213 -381 2 3.81642 6.7886 2.60252 -0.785086 8.11893 4.5328 -382 1 3.89262 11.6088 12.227 13.3033 3.31132 5.82178 -383 2 4.72051 12.1032 12.348 -1.72331 -9.21471 -1.78635 -384 2 3.26281 12.0921 12.7526 -14.3078 7.33513 5.3451 -385 1 5.45444 3.88172 15.8755 10.9934 63.7886 22.8921 -386 2 5.90627 3.24049 15.3708 25.1493 -29.4334 -15.1609 -387 2 6.11665 4.65725 15.9739 -37.1513 -37.4972 -5.17498 -388 1 14.4636 10.317 4.39501 8.04256 -17.7362 -43.5508 -389 2 14.9051 9.88853 5.13417 -2.05112 -4.59794 0.583625 -390 2 14.7084 9.81768 3.53446 -13.0506 20.827 46.8358 -391 1 7.94949 17.2895 9.24469 -12.4073 10.6503 -4.49958 -392 2 7.23447 17.5423 9.86969 11.4984 0.663317 -18.2334 -393 2 8.01085 17.8889 8.47627 -8.74254 0.310971 13.2931 -394 1 4.4986 14.4237 3.96317 22.7921 6.59984 27.2073 -395 2 4.89523 15.3318 4.14709 -15.7294 -33.8816 -1.82578 -396 2 4.80237 13.7713 4.67129 -10.4496 32.1184 -24.135 -397 1 14.3358 7.38467 15.7635 24.4704 6.70756 7.84838 -398 2 15.2401 7.23754 15.391 -26.2451 3.74497 13.7384 -399 2 14.4998 7.83446 16.6232 -7.00308 -11.7114 -18.5693 -400 1 2.86875 18.2246 1.90934 8.22952 29.9251 46.5059 -401 2 2.54447 17.7626 1.17928 -17.7355 -34.6574 -39.0362 -402 2 2.08284 18.4154 2.45796 15.223 4.61378 -9.70941 -403 1 7.96139 1.61197 4.52525 29.4796 -3.5692 28.5612 -404 2 7.4985 1.83317 3.72811 -4.47294 12.8461 -13.1797 -405 2 8.84188 2.051 4.57628 -23.8244 -8.06079 -10.6756 -406 1 2.69247 14.1251 17.7583 -39.7925 -12.5472 14.0506 -407 2 1.78944 13.8074 18.0556 30.3506 3.26472 -13.0537 -408 2 3.33089 13.517 18.1683 -2.67461 8.7222 -7.81087 -409 1 0.711797 1.68055 13.8626 44.8563 0.102291 -15.8697 -410 2 0.854596 1.56791 14.7929 -2.34617 -4.64243 17.7358 -411 2 18.4557 1.86826 13.7064 -36.5874 5.33291 1.35002 -412 1 4.5582 18.5986 13.9691 17.69 -10.1212 -17.3986 -413 2 5.37614 18.0918 13.7297 -17.5363 18.7277 11.6893 -414 2 4.4096 18.4453 14.9034 -4.80692 -4.44744 5.40837 -415 1 7.10973 0.453475 18.3742 -17.6731 43.6393 33.9394 -416 2 6.99644 0.098599 17.5235 3.55611 -15.5456 -38.0778 -417 2 6.34312 1.05085 18.5323 11.5496 -19.3687 -0.295067 -418 1 16.0934 18.4421 14.1505 -13.5696 -24.3411 -34.6818 -419 2 15.444 17.7866 13.7542 20.5302 26.3107 23.9987 -420 2 16.0379 18.4915 15.109 -11.2087 -0.403296 -0.42938 -421 1 10.1156 4.52417 16.2956 -63.5341 -10.6596 -28.1335 -422 2 10.9808 4.34247 16.5381 54.6034 1.03427 17.4186 -423 2 9.84863 3.69679 15.8473 1.5569 12.8802 9.55133 -424 1 15.8226 17.9425 4.41327 -12.7412 7.89699 33.5898 -425 2 16.5547 18.5732 4.53052 -9.15632 -3.64108 -2.38506 -426 2 15.1071 18.2295 5.06915 28.1993 -15.1976 -35.9746 -427 1 6.9246 17.3574 13.7412 41.9162 15.5861 -1.52717 -428 2 7.49648 17.8115 14.4369 -23.1807 -22.4309 -23.3681 -429 2 7.52703 17.1963 12.9658 -13.588 5.84324 25.6525 -430 1 13.2892 6.57209 6.73437 -45.0771 -7.84691 9.23056 -431 2 14.2146 6.66317 6.83486 35.9508 1.69852 -11.4068 -432 2 13.0394 6.38579 5.82242 8.43649 1.47489 -3.25235 -433 1 7.6616 2.3861 9.17526 8.07841 -8.24756 -37.8228 -434 2 7.32169 2.39592 10.0555 -17.554 -3.79201 20.6206 -435 2 6.95914 2.1022 8.53308 18.9972 7.96045 22.8376 -436 1 15.1464 14.8771 13.6482 -9.08859 5.19149 1.30171 -437 2 15.0308 15.0223 14.6069 -2.64384 -0.244686 -12.5428 -438 2 14.3194 15.1152 13.1798 15.9342 -4.32482 12.4068 -439 1 9.29105 8.34315 3.70472 25.3147 -22.6228 7.1656 -440 2 10.1776 8.75859 3.73678 -14.6049 0.788849 -0.227964 -441 2 9.48378 7.39942 3.88081 -7.38963 16.6026 -2.51653 -442 1 17.6854 13.4687 16.4528 1.20699 34.422 -16.619 -443 2 16.7357 13.4337 16.3398 -3.15338 -8.61752 5.60033 -444 2 17.8844 14.3284 16.0065 4.30498 -21.0483 11.9174 -445 1 5.04883 10.6547 2.58751 21.171 -14.0773 3.70172 -446 2 5.87017 10.3468 3.04382 -23.0848 5.17759 -4.78185 -447 2 4.55197 11.1441 3.22928 -5.68041 9.33128 13.9497 -448 1 3.70566 8.3683 10.3381 2.8322 -31.099 -4.13864 -449 2 3.86061 9.29726 10.2176 3.71195 18.7597 0.626964 -450 2 3.86652 8.14601 11.2715 -4.70232 11.1023 -9.34814 -451 1 16.1079 7.11641 6.33859 19.1617 -15.4194 -14.8444 -452 2 16.7241 7.70559 6.80408 -7.69122 -6.37409 -7.38138 -453 2 16.6678 6.33083 6.12136 -24.1396 12.8226 8.63966 -454 1 15.2027 7.00502 9.1117 -12.4455 33.5656 -30.1004 -455 2 16.009 7.42176 9.46585 -11.7729 -5.93044 -7.51071 -456 2 14.9881 7.51375 8.25647 14.3105 -22.443 40.0586 -457 1 6.4525 13.1649 12.9201 -14.4212 4.62434 6.2224 -458 2 7.2977 12.7289 13.0561 -0.519457 -3.7562 7.19322 -459 2 6.25327 13.7237 13.7059 9.03992 -10.4089 -22.4145 -460 1 12.1145 4.49786 13.0694 60.1541 40.3897 -0.599702 -461 2 12.3852 4.68406 13.9868 -12.8154 -8.572 -1.53547 -462 2 11.3952 3.9317 13.0199 -51.9002 -33.7145 4.15206 -463 1 11.3323 8.18365 7.8522 33.2694 0.481688 12.7059 -464 2 12.0901 7.73501 7.43634 -16.2057 -1.97452 -6.97761 -465 2 11.7651 8.45102 8.68662 -20.5523 -0.0583287 -5.01537 -466 1 17.1666 10.776 7.42179 36.6255 -17.1838 -28.5238 -467 2 17.7906 10.0723 7.08441 -19.5131 16.2155 23.227 -468 2 17.2793 11.4524 6.73733 -13.1225 1.2547 8.82205 -469 1 5.22802 18.1471 11.05 -26.218 -15.3265 2.15414 -470 2 4.73762 18.1049 11.901 9.27461 0.443739 -18.2338 -471 2 4.62535 17.7417 10.374 18.9971 14.5949 15.121 -472 1 7.56653 17.6363 1.80821 2.05543 -3.48119 51.3305 -473 2 7.65741 16.7768 1.42856 8.63412 -18.3953 -16.9352 -474 2 7.35855 18.2549 1.13994 -1.30452 14.3677 -27.7338 -475 1 1.85092 12.9256 13.6076 17.4877 19.0754 23.2488 -476 2 1.72104 12.4156 14.4258 -6.17153 0.259213 -13.4945 -477 2 2.19932 13.7866 13.9501 -9.51965 -23.6336 -9.57422 -478 1 9.73868 6.79159 14.8001 -20.4051 42.5069 -0.796717 -479 2 9.95236 5.95211 15.1529 11.7083 -38.3225 9.01974 -480 2 9.967 6.84408 13.8723 6.06139 -4.97285 -7.43337 -481 1 15.2087 4.3972 10.7794 -26.9028 -24.0998 -25.0358 -482 2 16.0082 3.89203 10.8637 24.0661 5.32644 6.50358 -483 2 15.2102 5.16148 11.3322 8.70888 13.5856 17.3899 -484 1 11.1963 6.12482 0.150068 -24.122 -22.6006 13.7234 -485 2 11.2381 5.20796 0.481504 11.6671 13.7026 -10.2768 -486 2 10.2374 6.21547 18.6186 16.3103 12.5014 -3.12394 -487 1 0.19533 11.3359 15.1413 -21.6592 10.769 -30.7731 -488 2 18.4021 11.874 14.3993 14.4722 -20.1415 31.2795 -489 2 18.4481 11.661 15.9631 4.68348 9.49999 -5.94609 -490 1 7.06882 9.13032 7.26059 -22.6631 -3.09615 15.424 -491 2 6.55985 8.40099 7.69941 15.0645 18.9564 -17.5163 -492 2 7.9725 8.82922 7.21375 6.85038 -6.33336 0.902711 -493 1 18.4578 15.4507 12.3537 6.97015 0.808933 -7.22971 -494 2 0.776651 15.5698 12.2511 -16.5258 -3.56518 7.28193 -495 2 18.1456 15.6789 11.4721 -4.11121 -1.28038 2.68538 -496 1 16.5694 4.36967 5.25107 2.45626 -29.8761 41.2812 -497 2 16.7744 3.81151 6.06026 -19.4928 29.4804 -23.4548 -498 2 17.3898 4.32671 4.78168 14.6436 6.44337 -19.6343 -499 1 17.788 3.06911 10.7078 8.19486 16.3181 17.0759 -500 2 0.075758 3.1322 11.0257 -18.3141 -4.46618 -10.1687 -501 2 17.6332 2.20749 10.3226 7.04824 -10.7221 -5.22745 -502 1 12.3142 0.064083 10.1758 -16.6046 52.5698 5.40656 -503 2 11.3746 0.384648 10.259 27.2889 -19.3162 -0.832384 -504 2 12.8178 0.919304 10.3228 -10.5773 -40.3011 -9.47381 -505 1 10.3666 9.83315 12.2981 15.5663 4.35939 24.9446 -506 2 11.1015 9.85063 12.955 -12.9587 3.49885 -14.3711 -507 2 10.1328 8.91188 12.2898 -2.48305 -14.5784 -4.85859 -508 1 0.463654 2.82678 7.01839 21.5285 29.229 11.0876 -509 2 0.875324 3.58845 7.48211 -15.1018 -9.47019 -10.8481 -510 2 0.770257 2.12665 7.58365 -2.10845 -18.3887 2.87796 -511 1 0.478371 15.2358 6.91004 -5.05906 -57.415 8.40739 -512 2 0.585298 15.6463 7.75647 1.85019 10.3725 13.8373 -513 2 0.556531 14.2524 7.18353 -2.63305 52.383 -27.2731 -514 1 16.9534 7.00251 15.3394 -15.9191 6.08615 -6.45156 -515 2 17.6338 7.63543 15.0899 14.1822 -6.8729 3.83609 -516 2 17.3093 6.19568 15.7235 10.8839 2.85836 -7.52482 -517 1 9.0001 12.4151 8.13768 -31.1102 30.9609 25.8163 -518 2 9.37386 11.8218 7.49742 -5.17233 -14.4246 -22.3971 -519 2 8.02402 12.632 8.03373 38.2843 -19.0142 -6.47162 -520 1 1.27238 1.95406 3.05803 -13.5483 -7.94682 -18.4152 -521 2 1.26084 2.61511 2.34121 0.274888 -9.5029 12.9388 -522 2 1.89031 2.22344 3.73293 6.76618 11.1556 -0.474465 -523 1 4.13907 15.1156 9.62039 -21.6353 8.89781 12.928 -524 2 4.07003 15.1439 8.65747 6.73796 -2.17255 1.87071 -525 2 4.96029 14.7006 9.86457 13.8731 -5.89958 -3.36363 -526 1 7.17628 2.17866 14.5671 10.1969 15.6665 0.500505 -527 2 6.99528 1.68402 13.7698 -5.58163 -4.27811 -6.1139 -528 2 7.62131 2.98432 14.249 -3.31044 -9.5634 8.35677 -529 1 18.6082 14.7131 2.1481 32.6395 -16.0207 -3.46113 -530 2 0.838003 15.1297 2.25966 -5.15041 -8.02703 -3.38947 -531 2 17.988 15.3544 2.42675 -27.9684 22.1971 4.74449 -532 1 9.94138 2.79524 12.9422 16.7157 -19.9527 -5.96647 -533 2 9.79404 2.1456 12.2228 -2.63367 12.9584 8.66897 -534 2 9.17835 3.36299 13.0326 -7.96092 5.51528 -6.54514 -535 1 2.80444 8.90955 13.0076 -17.7822 -13.1167 0.317539 -536 2 3.06361 9.80599 12.872 10.5962 22.9278 -4.25378 -537 2 3.5122 8.48618 13.4775 15.1932 -9.60442 7.00981 -538 1 3.236 8.3574 3.63664 -2.86765 -22.2709 68.2353 -539 2 3.45085 9.0718 3.07326 14.564 28.9211 -13.7717 -540 2 3.47645 8.58669 4.60794 -11.4307 -4.68562 -51.1711 -541 1 5.62853 7.18594 8.51094 8.63755 21.4894 2.16978 -542 2 5.46784 6.31815 8.13889 -3.95344 -9.53044 10.3317 -543 2 4.96415 7.47792 9.15047 -3.24726 -12.0183 -2.29801 -544 1 14.8757 1.26039 2.01768 8.95967 6.82752 -28.1452 -545 2 14.9353 2.01952 2.56559 -6.40438 15.8227 28.9683 -546 2 15.2784 1.60993 1.21235 -4.35761 -14.1118 -5.79377 -547 1 8.22892 15.2012 0.850139 10.8537 -12.6178 7.38979 -548 2 9.02213 14.9338 1.33488 2.38301 14.3333 -0.830013 -549 2 7.55366 14.6663 1.27665 -9.08858 2.03607 -6.2405 -550 1 15.6387 1.34587 7.23673 -38.2068 -12.1482 -8.38322 -551 2 14.9277 0.724731 6.91269 26.6184 17.4884 8.18161 -552 2 15.1173 2.1119 7.53894 10.4663 -3.86302 -4.52487 -553 1 4.90142 13.0959 18.5232 17.6249 -4.01801 23.9701 -554 2 5.32755 13.082 0.76977 -10.7656 0.632793 -19.6876 -555 2 5.44764 13.7122 18.0259 0.499955 -3.74815 -4.96885 -556 1 15.3368 8.46948 18.1479 21.2409 26.352 -19.7425 -557 2 15.8061 9.12264 17.5623 -15.5364 -21.5252 11.6976 -558 2 15.3318 8.91689 0.353875 -5.84476 0.442576 5.05054 -559 1 12.0708 3.01842 18.3809 -8.91332 38.2285 -17.9492 -560 2 11.9316 2.65996 0.60646 7.08072 -18.979 4.32412 -561 2 12.6022 2.47389 17.7995 4.78982 -18.1658 8.07002 -562 1 13.2139 12.6752 5.17768 -9.57044 10.0795 -9.57129 -563 2 13.7464 12.0348 4.69253 1.60656 -5.44915 8.62561 -564 2 13.2564 12.5123 6.11793 10.4898 -3.48459 7.66387 -565 1 6.05443 7.0356 0.031519 0.0605761 -19.9038 6.17744 -566 2 5.93935 7.95118 18.5019 3.71712 34.2187 -1.98634 -567 2 5.39095 6.86665 0.702638 -7.83388 -10.1683 0.476271 -568 1 17.7528 16.0276 15.0213 -25.9758 6.2762 6.79882 -569 2 16.9476 16.5457 15.105 3.54626 -1.67183 20.5845 -570 2 17.7479 16.0055 14.0813 22.8568 -13.146 -30.1028 -571 1 13.196 0.994907 16.5363 6.37162 1.07879 13.9702 -572 2 14.1481 0.997912 16.7614 -14.4757 -4.73392 -6.84542 -573 2 12.8833 0.094199 16.7238 3.07394 5.84273 -8.05351 -574 1 11.1253 14.5647 7.20271 13.6513 20.7581 -19.5035 -575 2 10.4007 14.3183 7.72981 -32.979 -9.13798 24.3252 -576 2 11.7186 13.8255 7.26943 15.8912 -3.80541 2.99114 -577 1 17.5081 8.62849 2.08107 17.5857 37.593 18.6886 -578 2 16.6801 8.63471 2.55495 -11.5266 -11.0229 1.73392 -579 2 17.5233 7.88242 1.516 -4.85302 -28.502 -20.2632 -580 1 12.3547 8.01168 2.02213 2.8693 7.47745 -2.1033 -581 2 12.2384 8.8582 1.54611 -1.5199 -14.1485 9.25757 -582 2 11.9739 7.3152 1.48261 -4.60849 0.564674 -12.802 -583 1 11.8761 14.6165 10.3364 -1.28632 -27.1744 -11.0444 -584 2 12.1004 13.7873 9.81464 -15.5434 34.4502 21.6186 -585 2 10.8993 14.6888 10.473 22.8986 -6.0814 -12.7032 -586 1 6.89524 7.05211 15.6117 2.70483 5.93472 10.8866 -587 2 7.81004 7.26536 15.3122 -19.1207 -0.823892 9.8847 -588 2 6.66676 7.54167 16.4408 15.3743 -10.0989 -25.4065 -589 1 8.00326 4.73593 13.4743 46.2088 18.1039 21.0673 -590 2 7.23337 4.7302 12.9572 -37.1051 2.19442 -26.1447 -591 2 8.40671 5.62958 13.343 -9.63909 -26.9075 5.20654 -592 1 13.4128 12.1818 14.2522 -5.46405 -2.8504 7.05596 -593 2 12.9414 11.3292 14.2657 10.1901 3.29349 -5.65079 -594 2 13.7875 12.315 13.3696 -1.58979 -2.51674 3.72795 -595 1 14.8395 9.42189 7.30548 -10.1492 -33.0314 -14.9507 -596 2 15.7087 9.765 7.42505 18.3001 17.1245 4.25051 -597 2 14.2269 10.0768 7.57319 -16.3703 19.68 11.0075 -598 1 12.6526 17.0686 3.07252 -25.5483 38.6692 13.4046 -599 2 12.8376 17.5237 3.93373 3.7914 -19.7635 -24.6942 -600 2 11.9913 17.6958 2.63477 29.3498 -30.5169 14.5322 -601 1 1.15545 7.13838 17.4647 -1.30818 10.8795 -24.4228 -602 2 0.330359 7.36323 17.9184 3.51096 -10.352 -1.0007 -603 2 1.05514 7.47868 16.5422 2.6229 -4.15873 21.1004 -604 1 12.7562 5.15096 15.6457 46.9745 -3.15458 16.4241 -605 2 13.4512 4.55662 16.0315 -23.8856 11.8204 -16.5269 -606 2 13.2414 6.00335 15.5788 -13.869 -10.6853 0.37407 -607 1 2.53993 3.38757 4.97618 -24.4059 44.0626 48.9955 -608 2 1.7609 3.18232 5.58922 29.5313 1.39757 -24.0522 -609 2 2.84154 4.31546 5.27885 -6.94106 -48.8689 -12.2378 -610 1 8.33186 11.2983 13.4548 -25.447 4.99647 44.923 -611 2 8.4244 11.0562 14.4444 7.04045 1.38295 -54.395 -612 2 8.91168 10.8786 12.8197 20.7237 -12.5345 14.2107 -613 1 12.8689 1.31514 13.3384 4.70567 59.9078 -15.5432 -614 2 13.42 1.58034 12.5659 -9.46235 -19.1343 13.2352 -615 2 12.4231 2.17844 13.5496 8.70338 -32.6779 -3.58081 -616 1 6.34008 13.7169 2.14963 -19.3306 -6.11379 22.757 -617 2 5.63978 13.877 2.82959 17.9638 4.85668 -21.8758 -618 2 6.88351 13.0442 2.56282 8.57629 -2.48731 -1.94932 -619 1 15.9206 6.61444 12.7992 -23.3103 -26.3741 2.68057 -620 2 16.3106 7.25195 12.2393 16.9755 20.6681 -18.7226 -621 2 16.4213 6.59661 13.608 7.79648 1.05266 12.4236 -622 1 16.8298 0.712824 9.59482 4.79811 -22.8344 -3.47194 -623 2 16.8791 18.3713 9.72616 -6.98639 26.8255 -1.99774 -624 2 16.5452 0.8605 8.67269 -2.39382 -2.67689 10.2173 -625 1 6.14624 11.7631 8.37671 0.189841 -56.9827 6.97012 -626 2 5.32447 11.4591 8.84151 16.7156 13.8425 -13.046 -627 2 6.64226 10.8931 8.20176 -19.0535 39.3101 2.14415 -628 1 2.88754 8.61261 0.453821 12.2401 -11.553 -23.675 -629 2 2.45212 8.04764 18.3917 -4.84247 31.247 26.7064 -630 2 2.34875 9.28564 0.895642 -13.4946 -8.81401 -13.4914 -631 1 10.1674 10.4623 6.50123 4.87464 -2.88608 -13.8248 -632 2 10.6087 9.69731 6.89122 -0.620763 2.00125 4.93232 -633 2 10.4694 10.4636 5.56932 -5.34739 2.02001 15.3519 -634 1 6.7142 15.6951 6.55167 22.995 7.84961 12.6004 -635 2 7.14328 16.1838 7.27089 -9.73558 -8.55589 0.364412 -636 2 7.21237 16.006 5.79102 -10.9792 5.43097 -10.3878 -637 1 6.445 13.1807 5.57797 -3.32019 -20.8794 2.06608 -638 2 6.7301 13.9465 6.07331 -1.80129 7.88671 5.96843 -639 2 6.09943 12.5433 6.22286 1.13913 6.90777 -2.85329 -640 1 16.8242 12.5629 9.83758 3.36613 -21.9924 0.476486 -641 2 16.9985 11.8651 9.16533 -5.29916 18.5903 6.02329 -642 2 16.5644 13.3844 9.42716 1.61266 3.35571 -10.8679 -643 1 6.03738 2.95058 2.86354 -7.51536 -24.4327 -2.00067 -644 2 6.40977 3.757 2.57075 14.9417 32.1903 -3.64532 -645 2 5.57703 2.61747 2.09059 -4.23441 -8.07329 -3.19257 -646 1 10.9114 3.33767 3.30112 3.4906 -2.16377 5.30702 -647 2 10.297 4.02722 3.58926 -1.61521 -6.66566 -5.52383 -648 2 10.5127 2.84524 2.57795 -5.77666 1.81375 -3.43243 -ITEM: TIMESTEP -10 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.68194 7.08301 17.95 -9.31723 -4.61569 5.17534 -2 2 7.78696 6.81626 18.2438 14.604 4.05464 -8.83536 -3 2 8.80373 6.759 17.0506 -2.23465 -3.10488 4.80291 -4 1 18.5422 8.2512 6.84005 -1.85374 20.2636 49.1182 -5 2 0.133718 7.9438 5.98823 13.4692 -17.0673 -32.1853 -6 2 0.402402 7.78616 7.5434 -4.29735 0.835788 -17.7519 -7 1 8.38516 18.5522 6.81414 18.1861 9.65042 -3.37417 -8 2 9.3349 0.126592 6.72298 -16.1755 -3.42506 1.43069 -9 2 7.92248 0.594936 6.31239 0.819355 -0.881225 3.09059 -10 1 6.59178 1.84314 11.71 32.0023 -4.98621 -11.2566 -11 2 5.89352 2.36713 12.0513 -24.1224 14.8358 13.0259 -12 2 6.19214 1.0378 11.3953 -8.69892 -12.638 -2.90229 -13 1 7.13386 5.75674 2.33026 -14.5408 0.616599 17.9391 -14 2 6.48306 6.1089 3.01881 22.5383 -2.3727 -34.6055 -15 2 7.09544 6.2305 1.47237 -10.8297 -1.47351 21.389 -16 1 16.2171 10.1491 16.1328 -28.1801 3.24526 14.6911 -17 2 17.0032 10.2274 15.6211 19.8027 8.68317 -10.1896 -18 2 15.8342 11.0337 16.2804 9.6716 -6.93987 -4.62354 -19 1 10.6069 15.0266 2.30703 -4.98248 -17.7421 -7.27467 -20 2 10.5595 14.4209 3.0573 0.524935 2.03122 3.93242 -21 2 11.0455 15.8043 2.63229 7.74565 12.2645 5.86516 -22 1 17.1614 8.24714 10.3877 8.07926 1.42828 6.48104 -23 2 16.5623 8.78009 10.9215 0.0316367 4.64377 2.31684 -24 2 17.9785 8.76022 10.2824 -6.97801 -4.40732 0.702868 -25 1 14.8935 15.8724 16.3278 20.2214 -7.01151 6.5945 -26 2 14.0152 16.2142 16.2283 -22.9266 5.478 3.03945 -27 2 14.9126 15.3591 17.1528 -4.85523 2.97165 -4.07838 -28 1 12.1655 13.3835 0.413391 7.36911 -14.3954 12.824 -29 2 12.1103 13.7323 18.1651 -6.85057 6.78658 -3.29346 -30 2 11.6807 13.9152 1.05851 -4.03153 8.23708 -7.75902 -31 1 9.27599 5.36662 4.05276 -29.4571 7.127 11.0843 -32 2 8.67176 5.26931 4.85064 22.4619 1.60875 -30.6294 -33 2 8.67539 5.53054 3.28716 9.26602 -4.36827 15.8404 -34 1 1.82909 4.27439 11.6483 -10.3032 26.7578 -2.81239 -35 2 1.73625 5.21877 11.9337 1.99226 -22.9368 -8.90994 -36 2 2.3645 3.83767 12.2983 6.89168 -8.93952 11.7704 -37 1 1.96701 6.83625 8.36791 0.700563 -10.6105 -3.76521 -38 2 2.46094 7.16371 9.10974 5.61647 13.7513 9.96296 -39 2 1.91553 5.8986 8.57777 -2.9792 -4.95164 -6.48224 -40 1 5.40472 4.39468 7.93775 -13.5219 -10.4794 -16.6571 -41 2 5.47247 3.43369 7.82443 4.19114 6.69916 9.09153 -42 2 4.75726 4.62849 7.24994 8.09624 5.59982 9.8174 -43 1 3.2394 2.92305 17.5474 -0.484589 33.1528 15.1222 -44 2 3.93082 3.31406 16.9898 -0.722116 -4.79924 0.441987 -45 2 2.93778 3.68549 18.1255 3.8058 -28.2307 -17.5498 -46 1 7.46921 5.27133 6.11017 -1.04832 -15.5011 48.3459 -47 2 7.90561 5.59719 6.92877 -0.90713 11.0324 -30.0179 -48 2 6.96076 4.54233 6.5205 0.0145083 12.7024 -20.8234 -49 1 9.7753 7.02229 11.9825 10.38 0.905424 28.7819 -50 2 10.3185 6.36588 11.5577 3.53671 -5.58238 -7.94156 -51 2 9.14507 7.32646 11.347 -14.6838 3.32198 -19.6076 -52 1 14.1071 3.54759 8.03608 -23.8038 4.02857 -21.7378 -53 2 13.5341 4.25359 7.68722 9.9361 -9.73972 0.838395 -54 2 14.4214 3.88758 8.85457 11.6 9.53944 21.926 -55 1 4.79933 17.2591 4.02624 -13.379 0.496236 -8.73431 -56 2 5.57386 17.851 4.10922 -16.5825 -9.69995 -7.24814 -57 2 4.20396 17.5018 3.27728 17.9024 3.63898 12.5287 -58 1 16.5033 16.6227 10.0525 8.55043 -2.52252 -17.4646 -59 2 16.0579 16.4137 10.8501 -12.2091 1.77219 28.6058 -60 2 15.9447 16.1927 9.39741 3.82195 1.69594 -5.2917 -61 1 1.95551 4.92482 0.485806 10.2127 4.96395 -0.662752 -62 2 2.54163 5.27617 1.19707 -10.7364 -3.48306 -18.9921 -63 2 1.87778 5.63364 18.4632 -0.0680824 -4.88148 10.5435 -64 1 11.8064 13.3616 16.2803 -11.2011 -32.854 -16.2783 -65 2 11.3068 12.5375 16.4476 0.201944 14.5536 10.5803 -66 2 12.2047 13.1237 15.424 4.38621 16.2025 8.43328 -67 1 10.1065 11.0626 16.9483 14.8798 -23.3813 0.89342 -68 2 10.5718 10.2022 17.1278 -15.1514 23.106 -6.44625 -69 2 9.22125 10.8281 16.6474 0.614925 -0.65596 2.44857 -70 1 11.7253 17.5378 13.4688 -9.94093 -22.0621 2.41868 -71 2 12.2582 16.9669 12.8891 0.443382 11.1567 2.15207 -72 2 12.0419 18.4322 13.3705 7.56806 8.72697 -4.32807 -73 1 6.34321 9.31538 12.2256 -11.115 -24.1278 -16.4431 -74 2 6.95505 8.9709 11.5438 -2.74015 10.4344 10.5225 -75 2 6.7633 9.99127 12.7388 17.4243 13.1424 4.46627 -76 1 16.2194 12.7233 2.70094 -4.61478 -5.953 2.95318 -77 2 17.0002 13.1906 2.44934 22.4693 3.83429 -6.00104 -78 2 15.5655 13.415 2.69545 -17.2672 7.42791 2.42646 -79 1 0.634553 12.563 5.85853 -28.5577 11.9856 -12.6208 -80 2 0.914444 12.5082 4.92832 1.43228 -1.32003 11.8657 -81 2 18.3286 12.8558 5.76638 29.2028 -10.3468 5.65715 -82 1 5.19236 16.3841 18.4962 26.3246 -0.931967 -7.14386 -83 2 5.89246 15.8922 18.0344 -14.3156 -2.38899 -1.49205 -84 2 5.72254 16.912 0.454606 -10.9177 5.22319 5.94171 -85 1 0.515157 7.6307 4.06432 40.0561 19.3507 -22.9165 -86 2 18.554 8.04388 3.41083 11.6748 -7.97607 10.9949 -87 2 1.4672 7.83805 3.73432 -48.6916 -7.92141 18.8197 -88 1 3.14333 8.89821 6.52388 -38.7347 7.47588 -5.16066 -89 2 3.55606 8.61579 7.33755 0.264066 -1.79724 4.80444 -90 2 2.15121 8.92424 6.67318 38.4004 -3.38228 -2.38687 -91 1 7.3156 10.3041 16.1747 -22.5262 4.44621 22.8692 -92 2 6.53394 10.4783 15.6406 9.03524 -0.350523 -4.2891 -93 2 6.93671 10.3234 17.0875 14.5541 -1.9474 -13.7178 -94 1 11.1094 1.06061 5.00017 -8.33223 -1.63593 -20.1003 -95 2 11.1653 1.90766 4.53999 7.02718 4.91961 9.72987 -96 2 10.7116 0.517103 4.29895 3.46448 -7.62041 12.1963 -97 1 4.44086 2.70257 13.2121 -8.76198 -6.25056 -12.8305 -98 2 4.61839 3.20254 14.0253 0.411253 -15.6801 0.294236 -99 2 4.37598 1.71769 13.3483 2.92355 28.3656 12.0639 -100 1 8.41481 10.0299 1.78755 2.58083 -12.9704 20.4417 -101 2 8.40154 10.6596 2.53141 -0.930044 -1.16348 -6.83089 -102 2 8.61337 9.15635 2.20556 -3.35942 21.7495 -11.7521 -103 1 10.5245 1.75336 15.553 -8.62776 -1.95945 -5.61675 -104 2 11.4377 1.70086 15.8172 12.2485 -3.82632 7.39579 -105 2 10.5516 1.84495 14.595 -9.16331 1.82149 -1.12185 -106 1 2.77042 12.9421 7.75317 -7.76237 -6.33315 7.0975 -107 2 3.33238 13.5624 7.27685 -2.67968 -0.352894 -3.41328 -108 2 2.03777 12.7029 7.16368 7.79305 2.46945 -1.53229 -109 1 3.64399 11.6862 5.32015 -16.8384 -12.8234 -6.75612 -110 2 3.34983 11.0669 6.0167 8.99611 10.2661 -11.4747 -111 2 2.85416 11.8487 4.76712 13.6242 -0.0526402 5.20338 -112 1 6.87773 14.4784 16.8504 -8.96924 2.55968 -2.39612 -113 2 7.58262 13.8601 16.6681 3.90388 -1.06505 3.99858 -114 2 6.56163 14.7581 15.9821 -2.66358 -1.99085 3.97159 -115 1 14.1744 14.5416 3.41044 10.3942 -0.651763 -8.74467 -116 2 13.655 15.3132 3.20132 -4.79611 11.1016 -3.67227 -117 2 13.7666 14.1672 4.18264 -6.53868 -10.5118 9.50782 -118 1 8.26761 18.1769 16.0723 60.4333 -9.62543 6.95109 -119 2 8.90915 17.473 16.3173 -32.2452 -3.35667 -3.16806 -120 2 8.92378 0.250762 16.016 -23.6515 10.2222 -7.97846 -121 1 4.73314 1.61844 4.90498 10.4838 29.1168 -20.5116 -122 2 3.92346 2.13642 5.08344 11.5633 -7.75976 -5.77828 -123 2 5.26159 2.15735 4.23518 -22.3286 -21.1319 29.8735 -124 1 15.1246 12.8394 16.4387 17.4381 -4.51065 31.9511 -125 2 14.6778 12.9897 17.2989 -1.10989 -1.43715 -21.8055 -126 2 14.5277 12.6911 15.7205 -25.4533 -1.78625 -11.0751 -127 1 15.7863 18.3852 16.7922 25.908 13.3822 31.678 -128 2 16.4574 18.6243 17.5189 -32.4234 -15.7026 -31.1655 -129 2 15.6278 17.4293 16.8067 2.01305 5.51074 5.25351 -130 1 1.13886 1.13555 16.5514 1.07915 19.6556 20.6288 -131 2 1.93696 1.57732 16.8903 -4.88731 -5.90564 -11.4186 -132 2 0.480719 1.50241 17.171 6.36092 -10.7053 -11.3623 -133 1 18.0845 4.58532 15.87 11.914 -13.2929 -3.66508 -134 2 18.5793 3.94883 15.3177 -8.66069 11.808 8.70591 -135 2 18.5822 4.70936 16.6848 -0.518448 -1.56194 -3.55701 -136 1 12.2302 16.9486 16.128 -37.9176 -11.5423 26.3029 -137 2 11.3914 16.5899 16.5469 36.4287 7.40626 -6.62059 -138 2 11.916 17.193 15.2634 5.93841 3.5336 -18.1806 -139 1 15.8788 2.54988 17.9721 5.087 5.67773 0.124923 -140 2 15.7549 3.4391 18.3687 -1.45045 -15.8437 -11.8457 -141 2 15.6801 2.58174 17.0093 2.38633 7.36977 18.7833 -142 1 6.70786 13.8001 10.254 -2.60372 -2.62943 9.53833 -143 2 6.60649 13.5148 11.1732 2.18143 10.2669 -0.00882184 -144 2 6.57676 12.9909 9.76432 1.5038 -4.69959 -12.8892 -145 1 10.141 18.2121 2.80409 9.87418 27.4677 -18.8777 -146 2 10.2555 0.291999 2.14056 -0.137226 -16.5556 14.9505 -147 2 9.2689 17.8819 2.61553 -12.127 -4.1331 -0.131977 -148 1 2.97228 17.7542 6.06181 -6.28377 0.301135 37.0401 -149 2 2.07671 17.601 5.72694 10.6784 2.25774 -14.0772 -150 2 3.63482 17.801 5.37776 -0.270923 -2.52512 -18.6151 -151 1 12.5659 17.001 7.96656 -23.415 -18.3905 24.197 -152 2 11.9071 16.2804 7.97312 11.7411 4.46809 -11.7089 -153 2 12.3405 17.4671 8.78984 12.2149 7.72109 -10.0441 -154 1 14.887 15.2779 8.2893 -14.8827 1.47652 2.73183 -155 2 14.0296 15.7117 8.25541 -5.1427 0.792443 13.0916 -156 2 15.1979 15.4906 7.42354 24.2513 -3.00083 -20.068 -157 1 17.5454 18.3111 0.374663 -13.7707 -4.14946 -2.00055 -158 2 18.2555 17.754 0.11924 20.0055 -25.3354 -15.9225 -159 2 18.0059 0.295965 0.896687 2.592 26.2966 16.2474 -160 1 0.909555 10.373 1.4127 -25.0541 -38.6286 23.1399 -161 2 0.0989843 9.87796 1.71715 28.402 10.794 -7.01331 -162 2 0.540787 11.0804 0.922273 -7.26144 30.0328 -22.846 -163 1 1.56438 12.1819 3.32547 9.10171 15.3717 9.49092 -164 2 1.376 11.5384 2.66679 -5.32309 -27.3061 -8.25977 -165 2 1.61002 12.9703 2.79202 3.36268 15.5511 3.76031 -166 1 0.549815 17.2556 4.8751 10.3167 15.4421 -19.2536 -167 2 -0.00199658 17.9163 5.26632 -10.5855 22.2192 -2.30371 -168 2 0.434878 16.519 5.43169 0.723696 -37.6018 20.4622 -169 1 1.10394 1.00198 9.3932 22.7427 9.86492 -7.57605 -170 2 1.42144 0.685439 10.2466 -8.09769 -6.36772 6.76546 -171 2 0.213433 0.697197 9.27667 -15.9263 -9.88137 4.21803 -172 1 16.7947 2.33275 13.2864 3.73194 4.84267 -27.3174 -173 2 17.0439 2.54012 12.3481 -6.98409 -4.39606 26.1758 -174 2 16.4729 1.42155 13.294 0.162444 -0.657512 2.21945 -175 1 2.4659 15.8297 12.1956 27.3811 -11.2673 13.1923 -176 2 2.9226 15.5311 13.0144 -9.82996 7.11615 -19.573 -177 2 2.93231 15.4201 11.4444 -5.86947 6.23921 4.54204 -178 1 16.4361 15.5441 5.94616 -3.08145 19.3328 -8.8947 -179 2 17.3593 15.4783 6.2724 -11.5576 7.7283 -8.52746 -180 2 16.3183 16.2893 5.29043 11.1937 -18.2696 22.1006 -181 1 5.84475 5.01999 11.7951 -3.08481 -3.45829 -4.75382 -182 2 5.52388 5.87345 12.0737 0.2772 11.9484 7.56792 -183 2 5.11411 4.43946 12.0133 1.47645 -8.9756 -0.689037 -184 1 15.224 4.86392 0.726277 -25.4938 -12.7349 25.4219 -185 2 14.7355 4.51715 1.53205 23.492 12.9767 -22.6649 -186 2 14.5328 5.02763 18.7193 1.17802 2.78752 1.94947 -187 1 16.3449 16.2967 2.11437 10.483 7.37611 -22.6614 -188 2 15.9997 16.7982 2.83675 -10.4405 6.50893 22.1211 -189 2 16.6677 16.9984 1.52582 -1.93062 -9.0043 0.169523 -190 1 0.302094 4.87802 3.79689 -13.2533 37.9479 3.00012 -191 2 0.313912 5.8808 3.95538 6.86913 -44.9842 -7.10747 -192 2 1.1462 4.49233 4.0346 3.71094 3.5442 4.02727 -193 1 2.9221 14.9895 15.0397 8.46471 -6.33736 14.5665 -194 2 3.00495 14.6058 15.9566 -9.31495 16.4585 -22.1508 -195 2 2.45729 15.8402 15.0938 1.85721 -3.29548 9.95349 -196 1 1.12 14.5717 9.56227 17.989 48.8934 -19.0037 -197 2 2.07414 14.5222 9.32346 -20.956 -13.4859 7.84449 -198 2 0.791626 13.7731 9.9282 4.87275 -29.8773 11.3577 -199 1 13.6624 16.6636 11.5457 -10.5327 9.77879 -22.0557 -200 2 13.3286 17.4311 11.0186 6.18992 -14.9435 17.5347 -201 2 13.3805 15.8992 11.021 -2.34987 0.215756 7.80532 -202 1 4.73359 1.47857 0.718618 -25.3973 -6.06392 2.87887 -203 2 4.17185 2.00661 0.129453 7.95287 0.81937 2.61464 -204 2 4.09095 0.858388 1.12753 14.212 5.94905 -1.43657 -205 1 1.42476 18.4735 11.9056 -5.99404 19.5083 -8.93412 -206 2 1.23513 0.382953 12.6723 -0.378912 0.915416 0.341246 -207 2 1.89505 17.7259 12.2433 7.21066 -16.1249 4.04173 -208 1 11.5448 10.106 4.11346 25.2596 15.8213 -25.5125 -209 2 11.5283 10.5663 3.22641 -2.70186 -14.3529 26.6987 -210 2 12.5027 10.081 4.37886 -27.2068 -0.404219 -8.52489 -211 1 8.37485 12.1748 3.75184 -11.9448 24.9759 46.3975 -212 2 9.17743 12.5878 4.11803 1.10724 -8.54244 -18.9118 -213 2 7.75197 12.4339 4.49102 7.61965 -18.0915 -33.0697 -214 1 14.3244 4.03247 3.293 11.3964 4.48411 20.4985 -215 2 14.943 4.18459 4.05162 -10.8147 -3.75721 -20.4981 -216 2 13.4909 4.45368 3.55282 4.29688 -1.92648 -2.70238 -217 1 5.58313 1.77339 7.50694 -37.3093 -46.6507 29.7736 -218 2 4.97145 1.12464 8.0478 36.2685 39.0776 -31.448 -219 2 5.37556 1.59155 6.57949 1.79923 3.69516 -0.386563 -220 1 17.9058 1.11523 4.88403 9.14173 18.8744 -7.73144 -221 2 18.4454 1.57607 4.20954 -6.0377 -15.1011 6.62684 -222 2 17.7347 1.81107 5.53023 -2.74058 -7.94095 2.09707 -223 1 6.8279 9.39776 4.48823 3.62694 -0.974221 -6.28613 -224 2 6.84568 9.51125 5.43283 -7.5389 4.30482 14.2207 -225 2 7.717 9.07508 4.31798 2.90721 -0.358573 -8.96695 -226 1 2.70207 14.9601 1.96467 9.48597 -9.94138 -22.1344 -227 2 3.35633 14.7518 2.62888 0.238693 -0.206349 10.2383 -228 2 3.16249 14.7444 1.12616 -13.7934 7.99556 12.9651 -229 1 17.2754 12.8959 13.1352 7.09139 -37.5845 3.69594 -230 2 16.3537 13.1102 13.3148 3.80173 19.6017 -1.81888 -231 2 17.838 13.6507 12.9698 -8.26303 20.1956 -1.14982 -232 1 15.0171 10.5799 1.38486 -27.8548 -28.8799 -20.6854 -233 2 15.5438 11.2121 1.82149 21.7425 28.5078 17.6295 -234 2 14.2994 11.069 0.967203 2.72678 -1.55793 4.42244 -235 1 5.71388 6.94387 4.52744 5.06868 -23.5408 12.0019 -236 2 5.87421 7.87915 4.41499 3.45829 8.88765 -0.888191 -237 2 6.40286 6.63416 5.14703 -8.303 0.627238 -7.76707 -238 1 8.10838 8.26645 10.1831 -2.58942 7.80898 11.2224 -239 2 8.62669 8.8788 9.66253 10.4484 9.83111 7.1505 -240 2 7.63286 7.80673 9.50478 -12.057 -13.4779 -6.03182 -241 1 13.5281 18.2914 5.80176 -22.4215 -1.8227 14.6872 -242 2 12.749 0.212336 5.63336 9.50875 -1.85743 -1.68773 -243 2 13.2346 17.7232 6.55015 8.07385 12.1374 -16.5266 -244 1 0.320637 2.55746 0.113707 -24.4854 52.0087 1.52013 -245 2 18.0083 2.70852 18.6241 7.28296 -16.9077 1.12853 -246 2 0.626424 3.4996 0.197011 8.79214 -31.4205 1.87945 -247 1 12.6453 10.9632 9.76861 -25.4211 42.834 -14.9231 -248 2 11.6492 10.8795 9.70071 37.3368 -7.50244 3.90461 -249 2 13.0228 10.1402 10.0352 -3.08107 -28.1376 6.91694 -250 1 0.78452 12.2807 11.0864 19.7349 -6.9692 -1.93691 -251 2 18.4749 12.3028 11.1225 -11.4863 3.49833 6.83674 -252 2 1.15231 12.659 11.9029 -10.6903 -3.95248 -3.68276 -253 1 5.04293 7.22507 13.482 3.09598 5.99749 -4.73795 -254 2 5.58886 7.93262 13.132 -0.232718 7.71962 -10.0141 -255 2 5.52798 7.00144 14.2755 -0.932575 -7.50807 9.86229 -256 1 1.28071 6.97469 11.8373 -31.3117 -37.3004 -11.5925 -257 2 0.492113 7.17802 11.3051 9.94401 -3.39318 6.90536 -258 2 1.685 7.80152 11.9673 18.2328 34.095 8.03536 -259 1 15.4541 9.47192 12.3133 5.85738 22.5951 5.06509 -260 2 15.5175 10.4638 12.3742 -4.62374 -31.0112 4.63394 -261 2 15.4968 9.06746 13.1992 -1.35817 12.6181 -10.5463 -262 1 16.6442 12.9519 5.45538 -21.4717 15.277 -31.3145 -263 2 16.3435 13.8787 5.41602 10.8128 -9.57177 19.5795 -264 2 16.428 12.7198 4.52965 10.5011 -15.0883 17.3079 -265 1 6.17539 10.0558 0.19339 -10.2788 -9.80575 -26.1597 -266 2 5.38875 10.4515 0.589333 6.07089 -1.52504 2.9393 -267 2 6.86188 10.0925 0.84877 11.0601 2.17112 10.8149 -268 1 12.366 6.05676 4.0416 -22.1854 -19.7968 12.9024 -269 2 12.3704 6.78834 3.44644 3.0333 22.1434 -14.5586 -270 2 11.4296 5.77117 4.03801 16.8285 0.174707 3.6691 -271 1 0.132536 12.8255 0.204274 -0.526736 3.63462 -3.55478 -272 2 -0.0162245 13.5547 0.824079 2.12041 -2.82991 -1.20796 -273 2 18.2367 13.045 18.0704 5.31007 -1.26571 4.82883 -274 1 3.83823 18.58 8.61434 -10.0824 -4.97514 -18.4016 -275 2 3.52069 18.2861 7.74382 9.30441 -4.40092 2.94392 -276 2 3.03757 0.306881 8.974 -6.88025 7.19874 10.2509 -277 1 7.39362 17.2775 4.45212 12.7302 8.58303 13.7229 -278 2 7.99666 17.968 4.81801 -14.6435 -15.1886 -20.2263 -279 2 7.36047 17.3088 3.48385 6.79225 7.50625 8.12072 -280 1 9.21958 17.0373 12.2266 15.7968 3.09867 9.11932 -281 2 9.35553 16.2013 11.7334 2.65662 13.4997 9.89778 -282 2 10.0046 17.242 12.8046 -16.9951 -13.4125 -19.4407 -283 1 13.3157 13.0082 7.94027 -17.3901 -31.9016 7.67948 -284 2 13.1929 12.2449 8.54147 -2.27359 6.97807 -8.06923 -285 2 14.1396 13.3907 8.1966 15.275 17.864 3.60781 -286 1 14.9833 2.94943 15.3513 6.95235 -3.03472 -25.2367 -287 2 14.3042 2.39498 14.9448 0.627233 -0.993788 8.39197 -288 2 15.6656 2.99789 14.6444 -10.442 2.78752 17.6131 -289 1 9.85751 15.5027 17.0048 6.47201 6.54967 -7.92386 -290 2 10.2825 14.6779 16.7304 0.0104739 2.25127 2.62159 -291 2 9.29444 15.3215 17.7618 -3.54568 -3.88732 3.90928 -292 1 11.2881 8.2507 16.5469 4.08161 11.4658 1.26949 -293 2 10.784 7.71518 15.9432 -10.4144 -1.78397 -10.2593 -294 2 11.7122 7.60386 17.1014 6.56418 -3.83522 10.5232 -295 1 3.78473 18.1936 16.723 -4.68023 16.7202 -12.0174 -296 2 4.25527 17.5912 17.2966 7.9068 -1.91441 12.6846 -297 2 3.78787 0.451609 17.087 5.31404 -15.3334 2.54941 -298 1 2.1979 4.10843 8.95106 26.9406 -12.5237 33.2314 -299 2 3.04044 3.62982 8.81286 -17.1971 13.1508 -10.8815 -300 2 2.16124 4.09638 9.93984 -10.9226 5.8942 -24.7105 -301 1 9.90906 10.3512 9.74092 -24.4032 35.3078 2.18412 -302 2 9.42476 11.1784 9.45919 17.314 -27.1904 0.11143 -303 2 9.91744 10.4013 10.7102 5.12409 -5.92526 -7.2544 -304 1 9.73754 0.812356 10.8589 -9.45704 -2.93658 -4.01088 -305 2 9.44076 18.5949 11.1517 4.40065 -9.39685 13.0528 -306 2 9.08713 0.996724 10.1835 0.761981 14.6946 -8.69624 -307 1 9.19301 15.2105 10.2107 -22.2036 -10.0383 -7.82623 -308 2 8.98025 16.0713 9.80369 1.46967 -14.8527 4.99479 -309 2 8.36662 14.6679 10.1029 23.0402 13.9843 6.10558 -310 1 0.991303 9.28993 10.3284 48.5242 0.758788 -7.3086 -311 2 1.23965 10.2015 10.4879 -14.9681 11.3684 1.41472 -312 2 1.89881 8.9146 10.1688 -36.1698 0.796544 3.16897 -313 1 16.8183 4.88742 8.19443 14.5542 -10.1877 33.2312 -314 2 16.1728 5.34475 8.77937 11.7085 -6.30946 -17.3069 -315 2 17.4003 4.3619 8.8005 -18.9368 13.5764 -18.1776 -316 1 14.6428 14.6932 0.395223 -8.43601 -1.47433 8.87339 -317 2 15.0319 15.2579 1.0921 -3.12605 -9.09789 -8.18687 -318 2 13.8519 14.2576 0.787234 16.4944 11.1317 -8.84191 -319 1 3.51972 11.0527 9.63241 -0.0258339 11.398 -8.76826 -320 2 3.50143 11.4368 10.5206 2.13389 -0.105265 -4.21661 -321 2 3.1724 11.7459 9.02999 3.72912 -11.0816 8.2725 -322 1 11.0404 10.8634 1.27208 6.70694 17.4362 -9.49329 -323 2 11.1727 11.6824 0.735781 1.31404 -20.4369 14.6488 -324 2 10.1116 10.6362 1.15363 0.362803 -1.95542 1.92755 -325 1 13.2201 7.06705 12.8916 -20.9652 2.88797 -6.38338 -326 2 14.1438 6.85164 12.9216 15.9393 -3.58362 1.12932 -327 2 12.7477 6.22232 12.897 3.28641 3.49729 -0.863357 -328 1 9.62872 1.89177 0.948251 6.96093 0.24991 16.0649 -329 2 8.76715 2.00519 0.577625 -19.1552 -2.18542 -3.65809 -330 2 10.1854 1.76875 0.19003 12.4655 1.79214 -8.44775 -331 1 10.594 13.5319 4.7375 16.0423 -1.41644 13.6035 -332 2 11.415 13.0379 4.93682 -11.8157 3.93147 -13.4525 -333 2 10.5255 14.1008 5.52348 -3.94863 -4.31219 -11.1546 -334 1 14.2685 1.70153 10.8945 -3.08057 3.85383 7.15216 -335 2 15.0552 1.23258 10.5836 3.50278 10.8149 -1.53255 -336 2 14.4104 2.66429 10.8947 7.37053 -8.35752 -2.77651 -337 1 14.6611 12.4198 11.7249 1.4364 -26.5965 -56.3444 -338 2 15.4897 12.4837 11.202 -5.7241 6.85295 22.6084 -339 2 14.0924 11.9909 11.0313 1.01548 12.4899 31.9742 -340 1 8.24953 5.08668 9.79072 -30.3058 0.287699 22.814 -341 2 7.41708 5.03925 10.3073 16.545 17.0491 -5.32162 -342 2 8.22462 4.2143 9.42755 11.9131 -18.3304 -16.4659 -343 1 1.59402 16.8187 18.3253 -6.20255 31.6963 -6.78121 -344 2 1.91227 17.2067 17.482 -4.95179 -10.2412 13.7563 -345 2 1.83336 15.9037 18.3179 8.32765 -17.6711 -3.36436 -346 1 1.43897 17.2464 15.3358 29.6054 -7.17934 -6.21787 -347 2 1.36087 18.1379 15.637 5.97318 20.4573 7.89508 -348 2 0.556137 16.9475 15.3273 -33.612 -15.1267 -3.09538 -349 1 3.72895 5.57357 6.20543 -8.92972 12.8219 1.61975 -350 2 3.23079 6.21113 6.76482 10.0758 -7.74032 -14.0976 -351 2 4.28418 6.06511 5.5772 -4.67021 4.78615 6.0759 -352 1 12.3529 9.4251 14.1822 19.6727 -43.1834 10.5387 -353 2 12.884 8.61082 13.8993 -22.621 36.8155 4.19437 -354 2 12.0516 9.14148 15.0731 3.60544 11.6456 -14.396 -355 1 4.03531 15.2728 6.90881 24.4865 3.71204 -3.62934 -356 2 3.44033 16 6.68284 5.60112 1.73001 -3.29651 -357 2 4.96253 15.5542 6.68078 -28.8575 -4.96404 7.1648 -358 1 0.605953 8.56457 14.8638 -0.120582 -0.391313 3.99343 -359 2 0.501042 9.52227 15.005 5.35221 -7.46858 -4.68281 -360 2 1.25554 8.44629 14.1506 -6.09669 6.93914 6.70414 -361 1 12.9734 8.36578 10.3368 20.5003 -18.2509 -7.79226 -362 2 13.7393 7.86937 9.99522 -8.8873 10.1321 -9.444 -363 2 12.9708 8.03443 11.231 -10.3099 3.90117 14.6287 -364 1 15.2894 7.6332 3.49269 12.7581 18.2329 -13.143 -365 2 14.5338 7.17315 3.08677 6.1918 -0.800492 21.6775 -366 2 15.5136 7.51531 4.43453 -15.4019 -14.7068 -6.3771 -367 1 17.3212 6.64473 0.0316567 -27.1824 12.6283 -1.8657 -368 2 16.771 5.99448 0.499966 9.26154 0.672542 -4.32476 -369 2 16.64 7.24337 18.2783 17.9792 -11.5061 8.92142 -370 1 8.80668 6.92454 7.83918 -24.3908 -17.2325 7.20576 -371 2 9.68081 7.28212 7.80962 25.7376 5.86496 2.86911 -372 2 8.71775 6.37228 8.64787 6.10597 9.33115 -12.275 -373 1 12.3202 0.615137 1.17425 13.6931 -3.72396 -2.19539 -374 2 13.075 0.992886 1.63957 -0.40119 2.44364 5.09949 -375 2 12.7571 18.5667 0.666384 -10.9298 0.853201 -1.96514 -376 1 5.6785 15.1027 14.5126 8.23045 15.6484 -5.86338 -377 2 4.72039 15.1784 14.5966 0.299323 4.01186 0.94539 -378 2 6.04535 15.9236 14.1081 -12.4379 -14.8055 10.7649 -379 1 3.83406 6.52943 1.68496 -5.12703 10.9404 0.999964 -380 2 3.44824 7.31709 1.2662 3.88585 -11.3877 -2.55221 -381 2 3.84338 6.82178 2.59771 5.33619 -6.06857 7.79227 -382 1 3.88904 11.6132 12.2401 8.95627 -8.79814 -2.40389 -383 2 4.75841 12.0277 12.3683 -7.0992 0.0294616 4.018 -384 2 3.233 12.1226 12.7151 -2.84239 9.6423 6.84851 -385 1 5.44987 3.87776 15.8711 9.04603 51.7105 12.2927 -386 2 5.99752 3.20763 15.4917 15.5436 -17.9801 -7.19396 -387 2 6.04703 4.69158 15.9698 -28.7283 -34.9666 -5.01916 -388 1 14.4605 10.3225 4.39641 11.4537 -30.5762 -31.9722 -389 2 14.8306 9.83502 5.14205 -5.39586 2.29688 2.9797 -390 2 14.6901 9.75629 3.58792 -12.4512 26.4694 34.1579 -391 1 7.94485 17.2962 9.23406 -29.3852 32.3044 -4.90329 -392 2 7.20157 17.582 9.8013 11.6936 -12.8295 -3.21694 -393 2 7.93254 17.9646 8.52624 8.85814 -10.3239 0.926379 -394 1 4.49873 14.4249 3.9575 27.1774 17.1098 41.9883 -395 2 4.83669 15.3326 4.20793 -17.2661 -25.1881 -14.2087 -396 2 4.80599 13.8528 4.71739 -13.53 13.4591 -29.2523 -397 1 14.3284 7.3854 15.7629 16.5671 6.07561 9.97379 -398 2 15.2454 7.23106 15.4511 -19.609 3.15959 8.32151 -399 2 14.4426 7.80786 16.6389 -4.4507 -8.27801 -15.1382 -400 1 2.87403 18.2247 1.90389 13.9577 30.3231 32.1513 -401 2 2.546 17.6397 1.25326 -17.0615 -24.6646 -23.5795 -402 2 2.12038 18.5502 2.43008 9.19244 -2.23706 -9.85686 -403 1 7.96361 1.60549 4.53489 27.0952 14.1367 0.307488 -404 2 7.49638 1.9472 3.77739 -15.4877 0.180801 -4.55719 -405 2 8.8215 2.06687 4.46869 -11.5471 -13.5362 7.94734 -406 1 2.67177 14.1298 17.7578 -32.0965 -17.6674 6.84649 -407 2 1.82063 13.6639 17.9969 26.9839 12.0838 -7.18622 -408 2 3.38659 13.5743 18.1098 -5.52669 6.70603 -3.66321 -409 1 0.723551 1.68725 13.8621 17.7332 3.27009 -2.43746 -410 2 0.829271 1.51069 14.7908 7.98206 -4.95309 12.0999 -411 2 18.44 1.84118 13.7764 -20.4783 4.25661 -8.09669 -412 1 4.55406 18.6 13.9636 17.2604 -7.63309 -9.35161 -413 2 5.43897 18.1924 13.8214 -18.4623 11.1021 3.79828 -414 2 4.32329 18.399 14.8757 -4.15164 0.0521115 2.41255 -415 1 7.10455 0.474046 18.3679 -11.2359 27.2348 29.1061 -416 2 7.12016 0.115813 17.4965 -1.63433 -6.1865 -23.0052 -417 2 6.24271 0.910062 18.5515 12.5771 -12.8936 -7.91243 -418 1 16.1005 18.44 14.1333 -36.4501 -27.5791 -6.57953 -419 2 15.3829 17.8174 13.8465 25.6281 20.8019 -1.7164 -420 2 15.9077 18.5395 15.0719 9.49834 8.44163 -0.14337 -421 1 10.1046 4.52059 16.2893 -46.9792 2.1543 -16.8809 -422 2 11.0012 4.49779 16.5541 31.7343 -4.51398 5.87687 -423 2 9.86248 3.65729 15.9089 12.0807 6.21086 8.83226 -424 1 15.8363 17.9271 4.41684 -16.1004 8.03032 22.5493 -425 2 16.5039 18.6299 4.52246 -8.60661 -6.24751 -1.3813 -426 2 15.0378 18.2098 4.9532 29.0614 -11.0784 -22.6438 -427 1 6.9284 17.3613 13.7353 43.359 11.4946 7.60179 -428 2 7.46858 17.7163 14.5015 -21.3841 -13.8198 -23.6549 -429 2 7.59514 17.216 13.0184 -16.6797 3.36376 18.1603 -430 1 13.2847 6.56451 6.73769 -14.228 -11.1924 -15.3605 -431 2 14.2169 6.67596 6.68467 27.6084 8.49537 10.422 -432 2 13.086 6.40899 5.80997 -14.9004 -1.60425 -0.509451 -433 1 7.67719 2.38409 9.18276 -12.7481 -9.95901 -21.449 -434 2 7.23781 2.34079 10.0234 -2.84678 0.492631 19.9336 -435 2 6.97018 2.11077 8.55354 21.5545 6.86467 6.74712 -436 1 15.1528 14.8764 13.6487 -19.1236 6.62595 6.09279 -437 2 14.9964 15.042 14.5941 6.3649 -1.885 -8.0702 -438 2 14.3208 15.1168 13.2045 14.5757 -4.46306 2.19701 -439 1 9.29857 8.33432 3.70772 10.6355 -8.13532 4.49802 -440 2 10.1502 8.81328 3.76286 -8.0776 -10.0517 2.73632 -441 2 9.46492 7.39019 3.89736 0.427871 14.9166 -2.52044 -442 1 17.6858 13.4785 16.4504 18.1421 12.8824 -2.9019 -443 2 16.7336 13.3749 16.3876 -0.564153 6.32044 -4.53985 -444 2 17.9415 14.3223 16.0098 -13.7235 -15.3212 6.57805 -445 1 5.04165 10.6569 2.59879 15.0811 -13.5005 18.1704 -446 2 5.79991 10.2916 3.10884 -13.8602 3.81488 -12.1379 -447 2 4.57944 11.1735 3.25148 -7.64374 9.33605 4.93504 -448 1 3.71156 8.35988 10.3223 2.69392 -10.4458 7.32 -449 2 3.86762 9.29314 10.1995 2.90356 12.3134 -9.75827 -450 2 3.79851 8.25131 11.2818 -4.19061 -2.88345 -8.87222 -451 1 16.1009 7.11278 6.31821 6.57165 -19.5926 -13.3215 -452 2 16.7556 7.67982 6.75754 -3.32154 -9.30994 -6.24555 -453 2 16.5222 6.22545 6.20359 -10.7974 20.4957 5.39095 -454 1 15.1877 7.01217 9.11633 -0.942582 31.3193 -31.4924 -455 2 16.0087 7.4094 9.45282 -9.93766 -6.26011 -0.320925 -456 2 15.0368 7.51069 8.25256 3.47491 -21.9129 34.3614 -457 1 6.44498 13.1525 12.9077 -4.11711 1.46333 8.37594 -458 2 7.24124 12.6683 13.1519 -1.65948 -2.61146 -1.33868 -459 2 6.29723 13.796 13.6274 -0.63037 -8.66373 -16.4588 -460 1 12.122 4.49686 13.0678 27.186 16.1548 19.2119 -461 2 12.2551 4.61131 14.0219 7.12074 5.87928 -4.56992 -462 2 11.3374 3.99971 13.0395 -36.5276 -21.5475 -13.6693 -463 1 11.3413 8.18743 7.85231 -9.00357 4.77407 0.37365 -464 2 12.0188 7.6639 7.39095 2.25052 4.68793 14.2505 -465 2 11.6381 8.44006 8.74837 5.13859 -10.097 -12.5363 -466 1 17.1781 10.7776 7.41775 8.98079 -10.5429 4.93206 -467 2 17.827 10.053 7.20793 -14.7505 26.0455 -2.01259 -468 2 17.1485 11.4724 6.73654 6.61625 -12.2683 -1.04931 -469 1 5.23072 18.1435 11.0535 -19.1878 -10.0323 -1.26774 -470 2 4.70405 18.0783 11.8789 8.35901 -0.713622 -15.9457 -471 2 4.65273 17.8196 10.3204 13.2116 10.9899 16.482 -472 1 7.5638 17.6255 1.82385 0.18941 -4.57957 5.58349 -473 2 7.78527 16.8134 1.38126 5.66428 -18.4097 -0.230917 -474 2 7.45334 18.2192 1.09148 -1.66074 15.0057 -4.75644 -475 1 1.8616 12.9257 13.6096 9.14642 8.79388 9.51824 -476 2 1.6025 12.3584 14.3568 1.58601 7.25854 -8.04733 -477 2 2.19519 13.7677 13.9951 -8.21693 -20.1216 -3.01678 -478 1 9.73071 6.79429 14.803 -9.96431 20.7294 -5.24946 -479 2 9.965 5.93538 15.1079 4.49059 -29.2435 15.7374 -480 2 10.0131 6.81015 13.8895 1.7202 7.35701 -8.16934 -481 1 15.2073 4.3815 10.7753 5.02149 -7.87008 -1.3136 -482 2 16.102 4.07091 10.8622 12.544 -14.2164 -8.54624 -483 2 15.2461 5.11302 11.375 -14.5847 15.9831 9.57625 -484 1 11.1932 6.12384 0.161263 5.03411 2.82645 3.69768 -485 2 11.3288 5.17786 0.364595 -11.2178 11.9329 -9.49937 -486 2 10.2678 6.33084 18.566 9.25768 -12.2342 6.14633 -487 1 0.186838 11.3278 15.1363 -29.5173 30.1692 -23.1318 -488 2 18.3705 11.8565 14.4078 15.8912 -24.6881 20.4884 -489 2 18.5399 11.8236 15.9183 6.48048 -3.45982 -2.85079 -490 1 7.07004 9.14522 7.26474 -13.1186 -12.9635 8.90657 -491 2 6.53932 8.3872 7.60207 7.2147 19.6305 -8.47997 -492 2 7.95552 8.78183 7.22801 5.51641 0.721385 -0.901037 -493 1 18.4462 15.4465 12.3531 0.397712 -4.42488 4.01328 -494 2 0.764911 15.5581 12.2944 -10.8471 -1.16552 -3.91149 -495 2 18.1036 15.6779 11.4829 2.90793 1.2817 1.1609 -496 1 16.5729 4.36464 5.24677 -25.0478 -7.96005 29.4563 -497 2 16.6771 3.95228 6.15287 5.89012 16.1194 -31.2199 -498 2 17.3789 4.38374 4.73556 17.0857 -2.87844 2.77648 -499 1 17.7776 3.07164 10.7152 20.2072 1.91324 7.6701 -500 2 0.0768882 3.1314 10.9751 -16.1773 7.43675 -1.86825 -501 2 17.7244 2.20926 10.3009 -7.90603 -5.17093 -4.6179 -502 1 12.3097 0.0632784 10.17 -5.23585 14.9609 -0.662134 -503 2 11.3669 0.329281 10.3192 28.4735 0.874848 -0.34084 -504 2 12.8997 0.858518 10.2668 -24.0851 -21.9241 -3.33166 -505 1 10.3626 9.82488 12.3121 10.8795 10.4681 17.7395 -506 2 11.1241 9.87716 12.9295 -11.9387 -4.40292 -9.54779 -507 2 10.179 8.8911 12.2253 1.1465 -9.5921 -0.185536 -508 1 0.479623 2.83009 7.02164 2.3472 21.5918 -9.19818 -509 2 0.779466 3.61946 7.51564 -3.03286 -18.4976 -0.625243 -510 2 0.704445 2.06385 7.54355 5.66126 -3.27927 9.79357 -511 1 0.467007 15.244 6.91284 -2.81724 -38.2268 -9.44322 -512 2 0.589986 15.6097 7.78713 1.11258 -6.7374 10.833 -513 2 0.615386 14.2454 7.00377 -3.57496 47.8567 -6.78063 -514 1 16.9531 7.01102 15.3314 25.0955 -6.26352 -3.35293 -515 2 17.7312 7.54015 15.1398 -4.24099 15.1997 -5.49373 -516 2 17.3882 6.19624 15.5982 -13.584 -8.29127 -0.013797 -517 1 9.00968 12.4205 8.1448 -47.4595 3.97518 -14.6445 -518 2 9.255 11.8265 7.44329 24.3825 -11.7648 -7.05727 -519 2 8.04408 12.5071 7.93332 27.0995 7.32888 21.0703 -520 1 1.26609 1.94093 3.05591 2.05426 9.79258 -12.831 -521 2 1.21698 2.59367 2.33971 -7.6512 -12.9321 3.35408 -522 2 1.90984 2.32941 3.65026 1.81811 -2.05605 5.16186 -523 1 4.13335 15.1162 9.63732 -3.37236 0.94273 -0.929026 -524 2 4.11982 15.1465 8.67375 -6.81504 5.04573 1.04836 -525 2 4.9784 14.712 9.81623 8.98269 -4.0071 9.77097 -526 1 7.18021 2.17978 14.5671 7.55504 9.68183 9.47496 -527 2 6.93575 1.71258 13.7681 -0.50379 0.233559 -6.02908 -528 2 7.66352 2.97784 14.2972 -3.4628 -8.48803 0.116771 -529 1 18.6085 14.7119 2.15295 17.2538 -25.5542 -3.98016 -530 2 0.854482 15.0949 2.23403 -8.04084 1.8593 -0.311551 -531 2 17.9464 15.3611 2.33256 -11.9957 20.7574 3.41759 -532 1 9.94838 2.78838 12.9451 -1.38176 -12.4025 -13.9087 -533 2 9.76343 2.19068 12.1969 8.49761 3.03822 8.73498 -534 2 9.19943 3.38599 12.9407 -2.82035 8.06337 4.45668 -535 1 2.81023 8.91387 13.015 -11.0947 -9.09099 -1.03322 -536 2 3.12702 9.79437 12.8576 7.30933 17.7942 -2.89213 -537 2 3.52626 8.44288 13.432 10.5553 -8.83156 6.15268 -538 1 3.22981 8.35572 3.63929 7.91603 12.3414 59.3292 -539 2 3.55022 9.08279 3.12704 6.39159 12.4302 -19.4578 -540 2 3.47038 8.64809 4.58003 -14.7797 -20.4427 -37.089 -541 1 5.63158 7.19787 8.5111 -16.5836 -10.0318 8.45115 -542 2 5.49703 6.26423 8.32413 12.2862 -3.4998 -5.25722 -543 2 4.92977 7.35667 9.15199 5.58983 12.4707 2.72685 -544 1 14.8806 1.27947 2.01044 -5.20911 -29.6221 -13.7523 -545 2 14.8531 1.98102 2.64457 3.54145 24.2946 3.1913 -546 2 15.2413 1.51873 1.14568 -0.321243 12.6895 5.96264 -547 1 8.23741 15.1928 0.849855 10.5438 9.56485 -11.8122 -548 2 9.03414 15.1092 1.40038 -9.07879 -4.36113 3.60062 -549 2 7.50349 14.6875 1.21874 4.98636 -2.78068 7.26539 -550 1 15.6325 1.34538 7.23629 -19.2726 -10.6819 -7.69516 -551 2 14.9548 0.715658 6.87861 16.0521 20.279 9.35294 -552 2 15.1584 2.15623 7.4957 0.78871 -9.00488 -4.70177 -553 1 4.90948 13.0908 18.526 11.7484 -4.19917 14.2638 -554 2 5.32661 13.1046 0.771936 -5.81675 2.26251 -17.1314 -555 2 5.47193 13.6353 17.9612 2.08739 -3.03703 1.40027 -556 1 15.3444 8.47528 18.1477 10.5782 11.2904 -17.9652 -557 2 15.7712 9.10441 17.5134 -10.1785 -13.1115 16.9911 -558 2 15.2549 8.94211 0.342082 0.277618 5.95495 -1.45242 -559 1 12.072 3.0348 18.3713 9.16845 -16.043 3.97866 -560 2 11.9997 2.53228 0.532204 -11.5106 10.3924 18.501 -561 2 12.5782 2.36842 17.9104 5.62845 7.32417 -26.0863 -562 1 13.2089 12.6783 5.18015 6.63876 -6.29032 2.85699 -563 2 13.7391 11.9795 4.78379 -2.73226 -0.00342211 -8.22979 -564 2 13.3831 12.5487 6.11225 -3.40081 8.86391 8.40941 -565 1 6.04915 7.04527 0.0350485 10.8742 -21.2203 -4.52865 -566 2 6.02805 7.99092 18.6226 -5.46576 23.9499 6.727 -567 2 5.33859 6.76219 0.618839 -5.51003 3.35157 1.33709 -568 1 17.7393 16.0214 15.0094 13.9302 -13.9422 41.059 -569 2 16.9573 16.5339 15.2303 -2.65419 1.12677 -17.6965 -570 2 17.9199 15.9264 14.0844 -11.8828 6.17072 -25.9912 -571 1 13.1897 1.00209 16.5482 9.0285 -11.9403 8.82412 -572 2 14.1531 0.926941 16.6936 -12.5978 2.36886 -2.70952 -573 2 12.8801 0.0805392 16.5939 -0.793518 8.62378 -3.88342 -574 1 11.1147 14.5676 7.20714 13.0879 22.2032 -16.1382 -575 2 10.392 14.3041 7.74555 -20.7251 -13.6554 17.189 -576 2 11.8256 13.9392 7.33494 4.5733 -4.90634 5.95678 -577 1 17.5119 8.63301 2.08454 0.0660302 9.5119 10.6671 -578 2 16.6736 8.51459 2.527 -7.33525 3.37542 8.64387 -579 2 17.5132 7.89769 1.49414 7.23803 -17.2019 -20.825 -580 1 12.3543 7.99739 2.01665 -2.5776 9.38468 -13.8973 -581 2 12.1955 8.87571 1.62365 2.26325 -8.37679 12.9533 -582 2 11.9634 7.39841 1.37453 -1.21895 -7.08079 -1.91625 -583 1 11.8862 14.6191 10.3431 -20.5633 -33.2885 -21.2052 -584 2 12.048 13.7971 9.8109 4.18347 28.6601 18.3667 -585 2 10.9021 14.6739 10.3387 21.4811 7.86907 3.51893 -586 1 6.88785 7.04202 15.6064 18.5625 21.2571 16.3476 -587 2 7.79496 7.28653 15.325 -16.282 -10.9681 -3.58347 -588 2 6.76913 7.58838 16.4136 -4.66142 -14.4555 -17.927 -589 1 8.00173 4.72633 13.4744 30.8534 11.0647 12.2619 -590 2 7.23536 4.76996 12.9314 -21.7993 1.23146 -17.3356 -591 2 8.43981 5.59806 13.3773 -8.25054 -18.6352 3.63378 -592 1 13.408 12.1818 14.2607 -3.38159 -13.7589 -5.77775 -593 2 13.0599 11.273 14.209 4.17969 5.9499 4.9999 -594 2 13.8015 12.3234 13.3884 0.552928 6.09909 4.73433 -595 1 14.8332 9.42219 7.30259 -3.18701 -8.441 -7.55641 -596 2 15.6639 9.86655 7.42287 15.173 5.4083 -0.0492361 -597 2 14.1987 10.0431 7.62107 -17.8235 6.30723 6.71627 -598 1 12.6528 17.0596 3.07812 -8.70602 18.4808 5.33985 -599 2 12.9496 17.4673 3.92869 -9.46791 -7.74089 -22.4319 -600 2 12.0101 17.6853 2.63014 23.5323 -19.7514 22.4129 -601 1 1.16198 7.14088 17.4585 -7.06812 8.47411 -13.2553 -602 2 0.305081 7.19087 17.9183 5.00325 -4.47293 -7.14563 -603 2 1.04973 7.54449 16.5661 0.440843 -6.25707 18.2149 -604 1 12.7703 5.1502 15.6519 20.537 -9.206 9.03076 -605 2 13.4569 4.49661 15.9358 -13.2491 19.9411 -11.3493 -606 2 13.2029 6.02791 15.5919 -0.675517 -15.6076 2.74775 -607 1 2.52973 3.39372 4.98628 -12.5021 24.9114 40.8727 -608 2 1.78336 3.12225 5.60975 27.8197 11.256 -19.0698 -609 2 2.94772 4.23746 5.36491 -19.3389 -38.1774 -13.5008 -610 1 8.3189 11.2987 13.4496 33.0028 -42.3062 59.2485 -611 2 8.52043 10.9592 14.374 -32.1909 27.8732 -26.3694 -612 2 9.06111 10.8351 13.0577 -1.72326 7.29715 -30.1092 -613 1 12.8789 1.33643 13.3362 0.40834 22.0058 -3.21803 -614 2 13.4118 1.44301 12.5159 -13.2456 3.30889 14.5055 -615 2 12.3632 2.16071 13.5095 17.0122 -18.2145 -15.4576 -616 1 6.34323 13.7037 2.15004 -8.90275 3.4942 1.01633 -617 2 5.67068 13.9831 2.80896 17.8093 -8.54249 -8.97759 -618 2 6.94017 13.0667 2.55763 -1.44693 0.407866 6.84109 -619 1 15.9207 6.60938 12.7941 -14.0219 -16.6873 -1.46208 -620 2 16.3665 7.21966 12.2297 10.4548 13.0291 -14.3606 -621 2 16.4032 6.61209 13.6164 4.57404 0.312906 11.3916 -622 1 16.837 0.713429 9.59537 -4.60186 -23.2491 -5.40047 -623 2 16.7766 18.3812 9.76009 1.861 23.059 -1.51736 -624 2 16.4539 0.846132 8.70764 2.52408 0.807103 8.64662 -625 1 6.14677 11.7538 8.37929 1.46343 -38.2042 -1.58984 -626 2 5.28119 11.5099 8.79312 19.6536 2.3972 -11.55 -627 2 6.62627 10.8955 8.13754 -23.51 30.7545 10.2414 -628 1 2.89887 8.61954 0.44521 -58.0253 1.44029 -30.8084 -629 2 2.28026 8.19904 18.4406 35.2092 -5.33136 7.34884 -630 2 2.23436 9.22701 0.790296 19.604 11.6332 17.9417 -631 1 10.1646 10.4607 6.5042 -2.67562 1.82661 -6.4385 -632 2 10.6119 9.73033 6.95167 0.990091 1.19991 -1.59039 -633 2 10.4858 10.4732 5.58284 -1.09389 -1.85789 13.424 -634 1 6.73063 15.6946 6.55447 -0.851851 -4.83477 5.20485 -635 2 7.09829 16.1491 7.32752 1.36873 0.436433 -10.1699 -636 2 7.02842 16.1335 5.74515 1.47904 6.69628 7.42626 -637 1 6.44804 13.1708 5.58287 -3.43311 -13.1021 10.8705 -638 2 6.66139 13.9646 6.07673 2.2473 5.97996 0.728386 -639 2 6.06157 12.5687 6.2363 0.868112 2.44944 -5.20285 -640 1 16.8203 12.5595 9.83963 -1.29973 -13.3798 -26.0882 -641 2 16.9797 11.9255 9.1094 -0.187484 2.38257 16.1818 -642 2 16.6351 13.3676 9.36293 0.809528 9.54538 5.72824 -643 1 6.04152 2.95052 2.84999 -1.13024 -25.4835 15.2707 -644 2 6.4006 3.79327 2.62573 5.01416 22.8678 -12.9444 -645 2 5.58314 2.5656 2.09763 0.434854 2.67004 -8.58918 -646 1 10.9107 3.32852 3.29939 -12.4238 -2.51051 -2.149 -647 2 10.2568 3.99067 3.55961 5.98057 0.0707186 3.553 -648 2 10.4887 2.88551 2.55708 3.841 -3.98893 -4.96007 -ITEM: TIMESTEP -20 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.69334 7.07477 17.9589 0.0661907 -8.15672 -5.93801 -2 2 7.76544 6.892 18.1438 2.06168 0.344835 4.67083 -3 2 8.87494 6.58302 17.1494 0.0923072 2.18051 2.08263 -4 1 18.5724 8.27759 6.8487 9.68108 -9.0135 5.9796 -5 2 0.0748736 7.96696 5.95521 0.0469709 2.78304 -15.7461 -6 2 0.399795 7.62446 7.38749 -2.21574 6.41883 6.02377 -7 1 8.4 18.5641 6.8134 3.87483 8.82198 -0.0595031 -8 2 9.32611 0.166963 6.70047 -3.24105 -1.28376 -0.166563 -9 2 7.89494 0.641414 6.41149 2.5055 -2.76566 0.153015 -10 1 6.59225 1.83896 11.6912 -0.275689 0.302437 5.80014 -11 2 5.92509 2.27303 12.2308 -4.07131 5.9643 -4.10931 -12 2 6.1821 1.00166 11.4658 -1.55571 -7.95905 -4.17259 -13 1 7.1255 5.73378 2.34451 -23.1841 27.0209 10.5427 -14 2 6.64356 6.29382 2.99422 10.5833 -21.9235 -2.45439 -15 2 6.93596 6.23963 1.54379 8.61204 -12.4491 -6.79559 -16 1 16.2118 10.162 16.1238 9.73263 11.3036 -6.58381 -17 2 17.0956 10.2901 15.7587 -2.05967 -6.96031 3.12171 -18 2 15.9212 11.066 16.279 -7.86411 -1.51367 3.55804 -19 1 10.6155 15.0016 2.3147 2.6864 2.11515 1.56294 -20 2 10.6002 14.5314 3.15674 -2.41534 -3.03603 0.679536 -21 2 11.0785 15.8209 2.51731 -0.0195897 0.981381 0.0978469 -22 1 17.1585 8.25197 10.4305 1.44624 0.93325 5.78222 -23 2 16.6499 8.94547 10.8694 -0.557047 -3.86734 3.9084 -24 2 18.0092 8.65295 10.2197 -0.225121 0.250414 -1.13708 -25 1 14.8741 15.8852 16.3481 -7.08493 -6.82471 0.413246 -26 2 13.9679 16.1979 16.3007 -7.09092 5.8218 -2.34027 -27 2 14.8494 15.2418 17.0641 6.82868 3.48864 5.90805 -28 1 12.1588 13.3817 0.433178 -6.27467 12.7595 -4.80914 -29 2 12.0352 13.6324 18.1551 4.79076 -7.76922 -3.88045 -30 2 11.6846 14.0735 0.910169 -3.08866 -6.36125 10.7585 -31 1 9.27449 5.40778 4.04397 -13.9365 -16.0184 3.55858 -32 2 8.80012 5.02015 4.81047 7.30704 13.9384 -9.37026 -33 2 8.62496 5.33174 3.3181 9.32114 8.483 4.67507 -34 1 1.82732 4.26294 11.6464 -4.04254 -2.69427 0.93532 -35 2 1.77693 5.20244 11.8864 -0.000737327 -7.07977 -0.141665 -36 2 2.24287 3.78422 12.3753 -0.858945 2.71416 -2.4423 -37 1 1.98268 6.82933 8.36887 -4.76513 2.22844 -15.7156 -38 2 2.36253 7.23451 9.15103 4.34961 -4.46197 5.21996 -39 2 2.01952 5.87123 8.47722 1.07428 0.125821 9.68028 -40 1 5.39566 4.39684 7.93565 8.0799 8.40992 8.79829 -41 2 5.46014 3.43633 8.01893 -3.87159 0.552259 -10.4859 -42 2 4.76986 4.63893 7.2446 -2.8004 -4.28351 -0.196723 -43 1 3.26324 2.92599 17.538 -6.48526 11.4036 5.90093 -44 2 3.9521 3.41084 17.0519 -4.33162 -2.5567 2.49087 -45 2 2.74469 3.58038 18.0606 14.1441 -6.64194 -12.4081 -46 1 7.47828 5.27232 6.10849 -6.04695 1.38866 -9.34596 -47 2 7.88111 5.94624 6.68322 -4.96979 -11.9122 3.47667 -48 2 6.82246 4.73008 6.58045 9.57964 11.031 7.72945 -49 1 9.77144 7.02208 11.9904 4.73189 -1.1383 -1.06285 -50 2 10.3467 6.38126 11.5734 3.30689 -2.46386 0.831607 -51 2 9.14216 7.24941 11.3005 -7.52384 3.80108 0.31383 -52 1 14.0798 3.55416 8.05513 -3.28328 4.35009 -1.93857 -53 2 13.7004 4.26501 7.52877 0.673114 -0.544944 -0.0617854 -54 2 14.5392 3.99696 8.77439 -0.252332 -0.945414 2.55344 -55 1 4.73763 17.2389 4.01031 -0.321378 8.61877 -17.0141 -56 2 5.59566 17.6635 4.11691 -0.835388 -5.76098 7.55997 -57 2 4.38449 17.6475 3.19969 -7.45685 -7.93836 11.3283 -58 1 16.5107 16.6056 10.0759 6.54448 8.81329 9.76337 -59 2 15.9397 16.7408 10.8388 -5.01232 -5.78767 -1.53078 -60 2 15.9723 16.2069 9.3894 -4.78788 -4.31379 0.495659 -61 1 1.96746 4.90416 0.450775 -1.81832 7.5424 0.20662 -62 2 2.57813 5.33173 1.07474 -1.76589 -7.7088 -3.71938 -63 2 1.58349 5.65244 18.6136 5.80255 -6.17515 -0.843526 -64 1 11.7761 13.343 16.2841 -6.04701 8.80367 11.8739 -65 2 11.2992 12.5177 16.4849 4.5736 1.77316 -11.3497 -66 2 12.2862 13.2596 15.4658 -7.12668 -12.5479 1.29578 -67 1 10.1128 11.0591 16.9331 1.69597 -16.074 1.546 -68 2 10.529 10.1874 17.0807 -3.30995 11.3925 -3.21813 -69 2 9.18388 10.849 16.7697 3.68635 3.27029 -1.84825 -70 1 11.7127 17.5197 13.4648 11.3019 2.11475 -5.22831 -71 2 12.331 17.0869 12.8651 -0.203424 -4.77186 2.96515 -72 2 11.9976 18.4453 13.422 -5.71015 -0.897636 4.76739 -73 1 6.35333 9.30557 12.2266 11.9787 8.60001 -4.91149 -74 2 6.91868 9.08658 11.4768 -7.06745 -10.6307 -2.02859 -75 2 6.87303 9.9972 12.642 -2.68502 3.03115 9.09234 -76 1 16.2229 12.7446 2.69624 -0.291567 -17.1772 2.14859 -77 2 17.0444 13.127 2.38556 1.82795 9.93981 0.639945 -78 2 15.5737 13.4355 2.84522 -0.398116 10.9003 -3.52894 -79 1 0.630414 12.571 5.87324 -2.78001 5.23525 -2.09291 -80 2 1.00794 12.4159 4.99822 -5.49855 2.79722 0.151968 -81 2 18.3568 12.8603 5.70082 10.405 -7.04854 2.54099 -82 1 5.20787 16.4001 18.4776 -12.5497 0.602195 -7.10426 -83 2 5.86464 15.8156 18.076 4.18722 4.70251 6.39081 -84 2 5.5918 16.9091 0.552483 9.38889 -4.76533 -0.723228 -85 1 0.52849 7.63403 4.08589 29.1287 17.8407 -12.6947 -86 2 18.5836 7.90722 3.36083 3.6478 2.13346 8.06342 -87 2 1.42012 8.03877 3.86645 -30.4536 -16.431 6.17599 -88 1 3.1381 8.91119 6.51072 -13.5755 -1.26875 13.9192 -89 2 3.59199 8.61596 7.312 -0.196935 0.713487 -8.34602 -90 2 2.19086 8.84537 6.73861 12.9731 1.00292 -6.41375 -91 1 7.31254 10.3111 16.1924 3.71601 3.69021 9.41051 -92 2 6.5835 10.5117 15.6001 -2.45726 -1.05124 6.16708 -93 2 6.97924 10.3433 17.1122 -4.5268 -1.10556 -13.1914 -94 1 11.1003 1.05051 4.99797 5.80988 -5.62906 14.1745 -95 2 11.3837 1.86623 4.56736 -9.38615 -1.44268 -8.87945 -96 2 10.7526 0.427875 4.34338 1.37635 7.2616 -4.61902 -97 1 4.41216 2.72626 13.196 4.39031 -15.812 27.2385 -98 2 4.68873 3.14242 14.0209 1.29771 13.5884 -6.24163 -99 2 4.35373 1.80262 13.5146 -5.93981 4.62314 -19.463 -100 1 8.39633 10.0477 1.8021 8.65231 5.58991 3.9521 -101 2 8.43584 10.7505 2.47552 -3.18527 -5.8592 -1.95349 -102 2 8.78245 9.25294 2.20632 -6.17245 6.11296 -0.869653 -103 1 10.5167 1.74791 15.5607 -12.987 -0.969766 6.95693 -104 2 11.4294 1.4693 15.6846 2.64548 4.13814 -6.20872 -105 2 10.3497 1.97094 14.6365 5.88046 -1.13362 -2.56443 -106 1 2.75172 12.9341 7.77038 -1.98364 -2.25212 -7.11701 -107 2 3.34024 13.5411 7.30753 1.72417 1.81116 5.40918 -108 2 2.20386 12.578 7.06153 -5.53374 1.90184 4.06344 -109 1 3.65904 11.6762 5.27167 1.4745 3.00351 -5.43274 -110 2 3.4246 11.0613 5.97769 -1.9036 -0.651658 -6.95213 -111 2 2.87422 11.8691 4.73548 4.37313 -4.77202 2.40024 -112 1 6.8497 14.4837 16.8623 -7.20011 -2.9268 7.54224 -113 2 7.64382 13.9472 16.8068 -1.68272 1.48794 -3.62778 -114 2 6.45279 14.5388 15.9848 5.36951 2.03983 -1.60361 -115 1 14.1732 14.5515 3.40534 8.00808 -4.71428 -5.83886 -116 2 13.686 15.3662 3.26714 -6.11485 0.946493 -0.0166146 -117 2 13.6673 13.9759 3.98664 -1.2314 3.40033 5.39954 -118 1 8.29912 18.1674 16.0589 -20.5282 -4.34905 -0.197762 -119 2 8.7408 17.3576 16.3653 13.9085 14.9544 -3.06277 -120 2 8.83266 0.312858 15.8727 12.6636 -13.3116 3.05514 -121 1 4.73053 1.62244 4.91728 3.73461 17.8941 -9.82498 -122 2 3.87083 2.07692 4.90413 8.70323 -5.84393 3.64668 -123 2 5.31846 2.19299 4.38363 -11.3635 -9.88313 3.69576 -124 1 15.0998 12.7921 16.4359 -16.5392 5.6559 5.83964 -125 2 14.613 13.1569 17.1797 9.93151 -3.40376 10.0434 -126 2 14.4182 12.7815 15.762 4.3611 -9.31248 -14.0367 -127 1 15.7898 18.3971 16.8042 5.79346 -1.22695 27.8179 -128 2 16.3329 18.5498 17.6117 -9.65553 4.21222 -20.1346 -129 2 15.4648 17.4968 16.9407 3.00983 3.14177 -9.23088 -130 1 1.14588 1.15091 16.5513 6.84042 -4.63386 -6.55399 -131 2 1.94328 1.67743 16.706 -5.62204 0.173811 5.06431 -132 2 0.528577 1.37004 17.2554 5.0728 5.5861 0.922174 -133 1 18.0913 4.5707 15.884 4.25376 -5.47852 -1.15194 -134 2 18.5654 4.01411 15.2573 -2.45188 0.25544 1.09753 -135 2 18.6545 4.64521 16.6589 -1.38654 0.113736 -2.45626 -136 1 12.2253 16.9711 16.1412 0.914186 -11.4555 3.91466 -137 2 11.5632 16.3741 16.5429 5.70701 14.4982 -7.43821 -138 2 12.0767 16.9746 15.1851 -6.52552 1.11271 2.73005 -139 1 15.9091 2.53324 17.9911 -0.813861 17.5084 -1.21546 -140 2 15.6764 3.36649 18.4268 1.17892 -6.2644 3.50604 -141 2 15.6868 2.72575 17.0644 4.5424 -10.5093 4.50867 -142 1 6.70264 13.8034 10.241 3.67042 13.5267 -3.47207 -143 2 6.65382 13.63 11.1889 -2.71481 -10.4168 -1.32753 -144 2 6.64075 12.981 9.74212 -1.13183 -3.39045 4.84834 -145 1 10.1303 18.2368 2.79334 3.88934 4.25391 -9.05815 -146 2 10.3528 0.228802 2.09034 -3.74927 -2.61302 6.3793 -147 2 9.24556 17.9143 2.58077 2.23777 4.46644 1.38681 -148 1 2.97822 17.7592 6.09436 6.84514 -11.0569 -16.6755 -149 2 2.2147 17.6257 5.53291 -18.2595 3.26089 9.16469 -150 2 3.66284 17.6557 5.427 11.9633 8.77303 4.67614 -151 1 12.5626 16.9639 7.98676 12.5848 -1.11028 -8.52053 -152 2 11.8839 16.2724 7.94525 -2.9484 9.81966 4.92503 -153 2 12.3706 17.6612 8.63222 -7.85492 -11.7975 4.91014 -154 1 14.885 15.2749 8.26678 1.09184 -13.1129 19.8008 -155 2 14.1202 15.8628 8.27106 1.10724 6.83397 -10.769 -156 2 15.4286 15.3633 7.48102 -5.52588 8.50153 -14.3957 -157 1 17.5862 18.2834 0.376986 -24.9344 -1.23553 -1.17468 -158 2 18.3469 17.8479 0.005767 18.8411 -2.89863 0.907383 -159 2 17.8259 0.448151 0.831731 10.0339 0.947456 -0.506579 -160 1 0.885899 10.3809 1.40397 7.22911 -11.5028 6.53987 -161 2 0.114071 9.81378 1.55479 0.851643 9.57639 -0.353744 -162 2 0.635753 11.1007 0.824785 -9.84019 7.34982 -5.0696 -163 1 1.59112 12.2023 3.3355 8.42913 -7.93475 21.5428 -164 2 1.38243 11.4488 2.766 -0.926106 10.11 -6.99043 -165 2 1.6499 13.0233 2.84482 -2.64968 -0.879455 -11.853 -166 1 0.551086 17.2511 4.8776 21.276 -3.63263 -24.3978 -167 2 -0.0762795 17.9651 4.97462 -6.3407 4.63135 13.3725 -168 2 0.558623 16.612 5.58807 -10.7338 -2.48853 14.1039 -169 1 1.11389 0.976548 9.40441 -9.70348 2.26791 0.52143 -170 2 1.20067 0.739298 10.3296 11.5619 -5.66825 6.05541 -171 2 0.194683 0.747268 9.24308 -0.993818 -3.51563 -8.196 -172 1 16.7801 2.33697 13.2827 1.26658 -2.58515 -3.42214 -173 2 16.9917 2.52603 12.3542 -2.2694 -1.44301 7.47438 -174 2 16.5315 1.40163 13.3451 -1.6586 3.84983 -3.29893 -175 1 2.50653 15.8317 12.198 6.9942 0.0378495 -5.39106 -176 2 3.03319 15.4932 12.933 -2.33393 0.151651 -5.20129 -177 2 2.92041 15.5438 11.3652 -1.63849 1.19534 6.62391 -178 1 16.4211 15.5676 5.95733 20.9565 28.2944 1.83954 -179 2 17.3426 15.5843 6.27645 -8.81355 -7.9692 1.26231 -180 2 16.3612 16.4166 5.46885 -9.28613 -17.0928 2.60564 -181 1 5.82453 5.03389 11.7824 5.33446 0.320875 1.57619 -182 2 5.57998 5.74431 12.3877 -7.39983 3.16893 -2.12011 -183 2 5.27405 4.27426 12.0034 -1.54313 1.61628 -0.196815 -184 1 15.2115 4.85871 0.718957 -12.3292 -1.21553 20.1953 -185 2 14.9951 4.64926 1.65891 1.99725 2.35951 -19.8125 -186 2 14.3839 5.18637 18.9796 8.05664 -2.8997 2.32554 -187 1 16.3489 16.3233 2.11444 -1.37403 -13.232 -8.15517 -188 2 15.9103 16.7203 2.87049 4.10511 7.42013 3.0617 -189 2 16.5474 17.0218 1.48672 0.743353 6.63736 2.3016 -190 1 0.282027 4.87119 3.80055 19.2835 17.3487 3.53091 -191 2 0.489613 5.83173 3.76503 -11.8967 -17.4303 3.14809 -192 2 1.11089 4.48306 4.11838 -9.18259 -2.61174 -2.176 -193 1 2.9303 15.0125 15.0392 0.0573492 -0.181072 31.7668 -194 2 2.82615 14.584 15.9186 6.41531 2.15453 -14.4377 -195 2 2.5906 15.8967 15.228 -6.81336 0.182398 -11.4579 -196 1 1.12223 14.6049 9.5632 13.1187 -18.7351 -0.898815 -197 2 1.97867 14.3698 9.19328 2.71847 14.7063 -6.21023 -198 2 0.940175 13.7592 9.98602 -14.9991 7.00648 6.43026 -199 1 13.665 16.6454 11.5316 -21.8339 3.0331 3.55613 -200 2 13.1746 17.4327 11.223 10.4467 -7.06131 -5.36321 -201 2 13.1002 15.9021 11.2581 8.49503 1.30575 -4.9094 -202 1 4.71709 1.47693 0.719081 -0.792104 -2.26487 7.67979 -203 2 4.13723 2.08795 0.242023 0.0358417 -6.61504 -0.0652634 -204 2 4.16248 0.903426 1.27536 -1.89276 3.42768 -9.42283 -205 1 1.43372 18.4947 11.8904 0.435024 0.903574 -5.06079 -206 2 1.25876 0.369488 12.6813 0.171373 0.403899 4.07674 -207 2 1.76959 17.6363 12.1756 0.0129122 3.12302 0.145238 -208 1 11.5344 10.1145 4.09755 11.0508 4.0163 -22.2825 -209 2 11.4066 10.5292 3.21014 2.38528 -6.34716 18.1192 -210 2 12.5036 10.0411 4.22804 -15.2135 3.993 -1.98571 -211 1 8.36281 12.1777 3.74701 -13.1943 -6.81146 -12.1909 -212 2 9.18722 12.6378 3.9579 -8.09176 1.3179 12.2751 -213 2 7.70079 12.2682 4.46238 18.0882 5.10492 -3.45512 -214 1 14.3344 4.02288 3.28855 15.2498 3.93213 6.6836 -215 2 15.0617 4.23514 3.91062 -12.0049 -4.72392 -3.76747 -216 2 13.5379 4.47251 3.60621 4.75183 0.0120405 -3.02562 -217 1 5.58434 1.74596 7.50985 -22.3692 -26.8297 9.12948 -218 2 4.91823 1.11394 7.92632 27.2868 23.8434 -15.8784 -219 2 5.43743 1.67946 6.54893 -3.28939 1.24453 9.56906 -220 1 17.9012 1.11073 4.88195 -3.31078 -7.47428 -4.80941 -221 2 18.5525 1.45486 4.25184 -3.70144 3.91348 6.86656 -222 2 17.7599 1.74881 5.59037 4.24211 2.13046 -3.7457 -223 1 6.8304 9.4053 4.48372 -13.6803 0.789023 -7.06041 -224 2 6.74666 9.48009 5.43928 9.48337 1.88908 4.46236 -225 2 7.74899 9.21301 4.27057 2.55497 -2.6247 5.048 -226 1 2.68932 14.9418 1.9668 -6.12139 1.43036 2.89635 -227 2 3.30587 14.7185 2.6759 1.77318 0.618157 -6.66396 -228 2 3.15681 14.9246 1.12432 2.70839 -4.47578 5.21755 -229 1 17.2859 12.889 13.1454 -5.46423 18.1991 -4.92566 -230 2 16.4361 13.3067 13.278 -15.9577 -14.9195 9.16742 -231 2 17.7285 13.6846 12.8505 24.3586 -1.49654 -2.29875 -232 1 15.0069 10.5712 1.38624 -2.11062 -3.1818 -0.491761 -233 2 15.5786 11.255 1.74854 2.03128 0.359313 2.4477 -234 2 14.2323 11.0405 1.08579 -5.34855 2.20107 -0.889893 -235 1 5.70672 6.90314 4.53443 4.24519 -5.28557 8.89432 -236 2 5.96576 7.83558 4.52332 0.860976 -3.32444 -1.54743 -237 2 6.34045 6.45199 5.11743 -0.773999 0.740319 -5.54545 -238 1 8.07933 8.28074 10.2171 -3.64639 -3.67369 23.1077 -239 2 8.76707 8.87858 9.90894 -2.7343 3.77639 -10.7375 -240 2 7.6749 7.81667 9.48055 2.86655 5.40525 -7.79011 -241 1 13.5084 18.3075 5.79227 -0.609935 12.5659 -0.945985 -242 2 12.8781 0.387145 5.63591 -2.7451 -9.905 0.332396 -243 2 13.1846 17.8335 6.57076 -1.7745 -1.29433 -5.46225 -244 1 0.277736 2.58212 0.118598 0.621477 -2.00702 8.56184 -245 2 17.957 2.7127 18.6839 10.2871 11.0559 -0.501636 -246 2 0.794319 3.38844 0.33639 -19.4232 -4.52538 -3.88061 -247 1 12.6801 10.9983 9.7602 -12.9965 -11.6862 -0.561246 -248 2 11.7228 10.8953 9.6485 6.19444 12.5166 -3.56604 -249 2 12.897 10.0826 9.9647 14.0656 0.707903 4.64438 -250 1 0.781933 12.2574 11.0872 -6.04901 -2.18816 6.07288 -251 2 18.4712 12.3682 11.1342 -4.62852 -2.97634 -7.25325 -252 2 1.06266 12.4852 11.9795 7.76729 1.60409 -2.26455 -253 1 5.05561 7.24886 13.466 -11.4852 -6.03635 -4.86876 -254 2 5.50236 8.03712 13.1394 10.7241 -0.576345 -1.34855 -255 2 5.49314 6.97472 14.2774 5.89817 7.37955 3.96262 -256 1 1.26581 6.94402 11.8396 4.62667 -0.613543 7.50244 -257 2 0.504801 7.20295 11.3208 -2.84364 2.86798 -1.49635 -258 2 1.66495 7.76854 12.1529 -2.34869 -3.61795 -5.23307 -259 1 15.4733 9.48228 12.3076 -4.70583 25.6475 16.0975 -260 2 15.3149 10.4406 12.4106 2.52372 -12.0579 -11.0564 -261 2 15.3983 9.16189 13.2139 2.67764 -6.7615 -6.72177 -262 1 16.6336 12.9201 5.4628 6.66579 -20.8603 16.0577 -263 2 16.5173 13.872 5.54201 -7.55482 0.841067 -13.5204 -264 2 16.4587 12.5944 4.56908 -1.3904 13.4091 -1.6671 -265 1 6.18458 10.0203 0.145227 10.7922 -3.52818 2.39688 -266 2 5.51531 10.431 0.700604 -4.05423 0.759005 -2.7608 -267 2 6.99302 10.1148 0.667984 -1.67417 -4.19008 -1.28624 -268 1 12.3589 6.06668 4.038 0.452115 -1.15559 12.336 -269 2 12.2616 6.902 3.56852 -2.7325 -0.676505 -9.18667 -270 2 11.4806 5.67315 4.10483 0.607886 2.8799 -4.57435 -271 1 0.151536 12.8218 0.203335 4.13456 -2.94622 -2.33064 -272 2 -0.0129983 13.5003 0.871422 4.06521 1.52419 -2.90371 -273 2 18.34 13.1254 18.0507 -1.07008 -0.669132 2.22617 -274 1 3.8124 18.585 8.59267 3.71655 -0.510361 5.11861 -275 2 3.56708 18.0759 7.80793 -6.58546 5.02297 1.51156 -276 2 3.01311 0.371537 8.92178 -4.29721 -3.94788 -5.16471 -277 1 7.41673 17.2735 4.46563 5.27699 16.8729 -12.8498 -278 2 7.96434 18.0381 4.66458 -2.5447 -1.66977 13.1327 -279 2 7.34622 17.3735 3.5102 -3.86431 -11.0257 -0.167405 -280 1 9.22722 17.0589 12.2393 19.2623 -14.5641 0.108859 -281 2 9.27149 16.2912 11.647 -4.87121 6.1965 2.03703 -282 2 10.0709 17.0037 12.729 -13.5572 10.6592 -2.64279 -283 1 13.3059 12.9585 7.95053 -5.93488 5.61094 -2.56551 -284 2 13.3162 12.2379 8.59837 1.79032 5.44422 0.740585 -285 2 13.8923 13.6822 8.21069 6.53108 -7.176 5.15054 -286 1 14.9676 2.9565 15.3436 -0.386658 0.574387 3.68052 -287 2 14.4202 2.18777 15.1252 1.77471 7.19316 -4.43588 -288 2 15.6633 3.03092 14.6718 -7.27619 -4.52831 0.823712 -289 1 9.86266 15.5244 17.0043 3.51131 -4.56125 -2.22878 -290 2 10.4016 14.759 16.7592 -3.4195 -0.793849 -1.98877 -291 2 9.23782 15.2217 17.674 1.65588 4.18023 5.21634 -292 1 11.2982 8.26605 16.5436 5.00814 15.3472 3.18516 -293 2 10.6561 7.79454 16.0057 0.999826 -4.04983 -0.0472571 -294 2 11.6606 7.65108 17.1873 -4.09078 -4.29715 -0.00155616 -295 1 3.81225 18.1964 16.7292 10.4788 2.16731 8.30533 -296 2 4.28955 17.5863 17.3008 -0.586781 -10.0924 -3.62086 -297 2 3.8829 0.368785 17.226 -6.17555 6.78007 -4.03101 -298 1 2.19803 4.12169 8.95254 -8.42555 5.0907 -8.8117 -299 2 3.07539 3.82533 8.67919 -2.6088 -0.1453 11.8715 -300 2 2.06404 4.00225 9.90658 13.5851 0.597917 -5.47855 -301 1 9.88178 10.3569 9.73038 4.79618 9.75255 -1.56513 -302 2 9.58096 11.2105 9.34815 0.270313 -13.7408 11.2463 -303 2 10.0884 10.4563 10.6769 -5.68787 3.60286 -6.41077 -304 1 9.72212 0.809424 10.8539 19.6856 13.2875 8.50656 -305 2 9.35568 18.6419 11.2241 -8.56647 -0.801274 -6.22283 -306 2 9.1718 1.19131 10.1642 -10.1616 -7.34852 -1.36201 -307 1 9.20808 15.1775 10.2123 -15.4381 -3.13199 6.73164 -308 2 8.85567 15.9769 9.80113 1.42232 -2.21967 -3.83769 -309 2 8.41617 14.6283 10.3808 11.8702 3.92611 -8.2586 -310 1 0.995689 9.3369 10.3259 -16.0333 -0.722577 -1.64132 -311 2 1.04111 10.3025 10.3672 11.5337 -2.90556 1.12718 -312 2 1.85551 8.94205 10.1494 2.50931 13.4523 1.23502 -313 1 16.8622 4.87275 8.19393 -0.422934 0.254968 7.2846 -314 2 16.1689 5.44633 8.57547 10.3862 -6.79292 -0.962882 -315 2 17.2033 4.29721 8.90095 -5.62498 7.92604 -8.45296 -316 1 14.656 14.7011 0.368319 0.981504 1.6367 -2.03469 -317 2 15.1464 15.0731 1.12238 -4.61865 -0.709772 -8.09446 -318 2 13.8079 14.3976 0.718239 6.88081 -1.79732 0.157513 -319 1 3.54139 11.054 9.61635 4.40574 2.25524 -6.23941 -320 2 3.65641 11.5568 10.4349 -3.33961 -4.79202 -0.629126 -321 2 3.06202 11.6341 9.00365 5.95536 0.511998 4.3162 -322 1 11.0657 10.8474 1.29636 2.92174 -3.12366 4.90686 -323 2 11.2982 11.6263 0.767958 -3.5102 -3.65436 5.75862 -324 2 10.1232 10.6698 1.15822 5.54645 2.63321 -1.67034 -325 1 13.2072 7.07995 12.8701 -0.715054 4.17079 -6.48984 -326 2 14.1512 6.89692 12.9697 -2.29399 1.70307 -2.36257 -327 2 12.7789 6.22148 12.7926 -0.519741 -2.64677 3.01569 -328 1 9.62848 1.89714 0.960589 0.144249 -1.27383 8.14422 -329 2 8.75389 1.7191 0.595255 2.62606 0.878667 -4.42234 -330 2 10.2646 1.96201 0.242782 -4.84565 1.17493 -5.89222 -331 1 10.5889 13.5223 4.7138 2.80012 2.67941 -15.7349 -332 2 11.4734 13.1444 4.59356 -4.0194 -1.02806 11.2737 -333 2 10.6142 14.0248 5.53615 3.92037 -3.05166 -0.671 -334 1 14.2891 1.71547 10.914 14.736 9.54636 -9.28817 -335 2 15.0906 1.40219 10.4788 -2.27816 -10.6125 3.67971 -336 2 14.438 2.66833 10.8812 -8.3278 1.7804 6.62982 -337 1 14.6539 12.3888 11.7057 -9.85382 -5.79197 9.84531 -338 2 15.5174 12.4906 11.2689 -13.4179 -5.72309 -9.10321 -339 2 13.9464 12.0325 11.1297 19.1264 4.07718 -1.67851 -340 1 8.24463 5.07042 9.80489 8.67652 16.3821 0.210642 -341 2 7.41075 5.25266 10.2586 0.116202 -10.888 -2.54867 -342 2 8.19641 4.23298 9.33202 -10.3006 -5.74151 5.58561 -343 1 1.57762 16.8331 18.335 1.68687 -2.26048 -0.033424 -344 2 1.80587 17.1847 17.4697 -0.252498 3.71983 1.68741 -345 2 2.01633 15.9753 18.3429 -7.29056 -3.61139 0.997127 -346 1 1.4432 17.2346 15.332 2.65894 -7.35401 -5.7102 -347 2 1.56202 18.0921 15.7447 -7.04866 6.37518 1.22888 -348 2 0.495246 17.0477 15.225 10.7628 4.03376 7.259 -349 1 3.71499 5.60328 6.17396 -2.46237 18.0728 1.59518 -350 2 3.14409 6.20568 6.67532 2.19379 -7.75625 0.984178 -351 2 4.32024 6.21155 5.72591 -1.08806 -7.05296 -5.84211 -352 1 12.3532 9.43776 14.1893 13.0079 -11.8089 -5.25996 -353 2 12.7562 8.63341 13.7793 -8.52026 15.4152 14.9752 -354 2 12.1872 9.21442 15.1219 0.0848175 -4.0166 -10.4276 -355 1 4.03165 15.279 6.91423 11.4052 5.55751 -7.84178 -356 2 3.54353 15.996 6.48767 -3.99323 -1.71496 7.04649 -357 2 4.96733 15.4866 6.74143 -6.91754 -4.3684 4.91577 -358 1 0.598678 8.56195 14.8837 5.20406 11.6905 0.774862 -359 2 0.593362 9.51845 15.0326 -4.59172 -3.85379 3.33684 -360 2 1.20863 8.47913 14.1435 0.530109 -4.80423 2.60663 -361 1 12.9822 8.33824 10.332 -12.7812 8.13505 -15.7365 -362 2 13.7449 7.91273 9.91994 1.65618 -4.07378 8.99333 -363 2 12.9305 8.07685 11.2552 9.52621 -6.7264 2.9301 -364 1 15.3077 7.66451 3.49902 -16.235 -26.2008 20.478 -365 2 14.5457 7.14577 3.24297 -4.72624 11.0142 -23.2354 -366 2 15.4625 7.21195 4.33822 21.3334 18.0327 3.91528 -367 1 17.3129 6.65992 0.0418436 1.52354 1.06354 -1.27952 -368 2 16.9014 5.84978 0.373955 -3.48337 6.90323 -1.87832 -369 2 16.58 7.23266 18.3971 4.62858 -6.17573 2.16922 -370 1 8.83009 6.92284 7.82744 0.252992 -5.92817 5.57761 -371 2 9.76137 7.15634 7.81451 4.22584 7.3373 -3.58966 -372 2 8.73794 6.33872 8.59756 -2.97854 -0.622916 -4.66555 -373 1 12.3396 0.625886 1.18148 -8.16379 -0.652746 9.01197 -374 2 13.1345 0.755236 1.71568 4.24005 -1.61972 -8.33969 -375 2 12.5055 18.5332 0.58867 3.80642 2.13695 -0.293066 -376 1 5.66619 15.1148 14.5143 -6.5884 11.0519 3.391 -377 2 4.74474 15.2404 14.7783 -0.0534379 -6.99417 -3.01637 -378 2 5.9729 15.9975 14.2655 4.1321 -4.56061 -2.72375 -379 1 3.84883 6.51764 1.70764 -0.24517 -12.2729 -5.84301 -380 2 3.34882 7.24325 1.31145 3.38543 6.95106 5.25371 -381 2 3.97654 6.73657 2.63696 -3.88246 4.168 -0.0932901 -382 1 3.88114 11.6142 12.2659 5.57001 4.81087 6.19714 -383 2 4.75444 11.9544 12.4977 1.45427 -2.38077 -3.49117 -384 2 3.27884 12.2304 12.6965 -5.21243 -4.02352 0.863052 -385 1 5.43603 3.86764 15.8623 7.54926 19.6814 5.52869 -386 2 6.13377 3.21124 15.7334 -3.30504 1.34649 -4.68995 -387 2 5.89589 4.73554 15.9355 -10.2176 -19.0214 -2.32011 -388 1 14.4546 10.3201 4.4055 -4.6195 -17.8145 -6.66778 -389 2 14.5894 9.8066 5.2203 1.29615 2.58376 -6.73886 -390 2 14.6351 9.71867 3.64602 0.226975 12.0799 18.4878 -391 1 7.91148 17.3357 9.20787 -1.7112 -7.64626 2.59046 -392 2 7.14677 17.4921 9.78359 1.89149 7.49144 -9.53339 -393 2 7.98506 17.9868 8.49476 -7.16328 0.988414 5.46347 -394 1 4.5072 14.4394 3.95775 1.71054 11.4257 7.67338 -395 2 4.60793 15.3916 4.19235 0.708777 -20.878 -0.615863 -396 2 4.75094 13.8726 4.71695 -2.09911 13.0171 -9.33913 -397 1 14.3103 7.38832 15.7657 0.217846 1.64546 9.18842 -398 2 15.2433 7.23588 15.5844 -0.0812074 1.42566 -0.574095 -399 2 14.3036 7.75428 16.6621 0.0607731 -0.988243 -5.21848 -400 1 2.8988 18.2304 1.89629 8.58281 11.0644 9.98123 -401 2 2.46496 17.5082 1.44481 -2.59003 -3.64619 -8.76243 -402 2 2.19471 18.7603 2.28641 0.940953 -0.0494932 1.95923 -403 1 7.97286 1.6093 4.54004 -3.7555 -8.8471 12.6183 -404 2 7.33734 2.04506 3.96057 8.79876 5.02214 -6.32296 -405 2 8.86006 1.965 4.43164 -2.78989 3.02833 -7.03085 -406 1 2.61876 14.1356 17.7492 -10.3822 -13.3904 -3.64852 -407 2 1.93119 13.4601 17.9363 9.46205 16.209 2.13837 -408 2 3.45643 13.7285 18.0162 -4.37303 1.24885 0.341178 -409 1 0.743255 1.70456 13.8731 3.59522 3.89384 -8.23695 -410 2 0.90651 1.38191 14.7629 -6.62821 1.47751 3.8543 -411 2 18.4338 1.82907 13.7582 5.96409 -0.15878 4.57237 -412 1 4.54424 18.6047 13.95 -3.57477 5.05027 -2.13798 -413 2 5.48468 18.3837 13.9843 -5.3566 -3.00882 -0.547935 -414 2 4.15141 18.3634 14.8001 4.77528 1.99072 0.545271 -415 1 7.0969 0.526127 18.3635 1.96349 3.45814 -4.17057 -416 2 7.27221 0.201121 17.4702 1.10961 -1.44826 4.33327 -417 2 6.13787 0.588122 18.4485 3.2238 7.1666 2.24 -418 1 16.0917 18.4266 14.1084 2.59329 0.57669 -10.3481 -419 2 15.3502 17.9157 13.7545 1.31994 6.64432 9.22997 -420 2 15.9271 18.7357 15.0116 -3.89333 -11.6647 -1.43214 -421 1 10.0733 4.52495 16.275 12.9842 -2.30982 2.85456 -422 2 11.0043 4.70153 16.4703 -2.64404 5.32532 -3.085 -423 2 10.0864 3.57376 16.1251 -6.72333 -0.470122 -1.54666 -424 1 15.8636 17.8904 4.42819 -6.03116 8.53171 5.31621 -425 2 16.3871 18.7073 4.48664 -0.23776 -8.88425 -2.03055 -426 2 14.9745 18.1441 4.72479 9.46919 -4.85854 1.60726 -427 1 6.9475 17.372 13.7315 15.8768 1.84738 17.2901 -428 2 7.36738 17.5483 14.6019 -4.78498 1.02898 -17.1267 -429 2 7.68915 17.2477 13.1142 -8.54431 1.43966 5.77183 -430 1 13.2923 6.53747 6.71701 -11.5961 -7.93952 14.6915 -431 2 14.1983 6.84596 6.64723 3.17712 4.25021 -11.0614 -432 2 12.8934 6.43009 5.84838 7.58936 1.28323 -8.80485 -433 1 7.69653 2.37351 9.2065 12.517 1.33593 -3.6252 -434 2 7.21057 2.29 10.0355 -5.39375 -0.506169 -1.44147 -435 2 7.12159 2.1318 8.46594 -3.32624 -2.43573 8.05936 -436 1 15.157 14.8759 13.6545 4.5209 -3.06988 2.24561 -437 2 15.0369 15.0852 14.5928 -3.37623 1.75424 -5.30162 -438 2 14.3708 15.1144 13.1546 1.18854 2.2818 3.55032 -439 1 9.31032 8.32311 3.71462 16.317 -0.492826 6.27183 -440 2 10.1522 8.77498 3.89843 -7.06732 -0.949504 -0.86517 -441 2 9.4815 7.39306 3.91425 -6.58464 2.05554 -3.01208 -442 1 17.7054 13.4931 16.4528 -2.79698 17.5255 -9.98682 -443 2 16.7518 13.3863 16.3682 2.15912 -8.30505 3.41837 -444 2 17.8443 14.3312 15.9805 5.97419 -5.13367 5.17943 -445 1 5.02162 10.6562 2.64136 -2.02283 -9.27068 2.47877 -446 2 5.69056 10.1772 3.15718 -2.95942 7.94984 0.663407 -447 2 4.59516 11.2797 3.2389 2.78246 -2.35968 2.10645 -448 1 3.7261 8.35111 10.2906 -2.0647 -5.12326 -12.4171 -449 2 3.87558 9.26669 10.0174 -1.23075 2.88832 6.28188 -450 2 3.61938 8.33938 11.2471 1.47542 3.72119 -0.959794 -451 1 16.077 7.09208 6.26442 0.512876 -15.8531 0.565556 -452 2 16.8498 7.55114 6.61759 -4.58181 2.74438 -1.19615 -453 2 16.2841 6.14901 6.36212 0.103861 8.35624 -6.71996 -454 1 15.1586 7.03156 9.12145 1.35056 8.00181 -20.3615 -455 2 15.9739 7.38238 9.50783 -5.19642 1.69713 -0.962803 -456 2 15.0724 7.48187 8.24992 4.14438 -5.93719 19.2407 -457 1 6.4279 13.1173 12.8809 -5.50985 -11.8139 -9.3985 -458 2 7.12916 12.5687 13.2568 1.68182 7.24531 -2.67671 -459 2 6.29661 13.8986 13.4214 -0.338885 -0.946459 7.65298 -460 1 12.1214 4.48617 13.0834 13.9874 7.50725 -12.3985 -461 2 12.203 4.65044 14.031 -7.85782 -1.77094 2.73271 -462 2 11.2673 4.11709 12.8488 -4.68474 -5.36964 10.3853 -463 1 11.3361 8.19542 7.84742 15.1179 -11.1226 16.1752 -464 2 12.0446 7.62229 7.53485 -1.89389 0.170875 -13.8157 -465 2 11.6069 8.28902 8.77112 -9.48953 8.11742 -0.143346 -466 1 17.184 10.7876 7.43369 13.5323 -0.921102 -17.174 -467 2 17.9233 10.1981 7.20811 -10.1233 -1.22821 11.3165 -468 2 17.1161 11.3267 6.63249 -5.49276 7.55364 9.36769 -469 1 5.23991 18.1348 11.0582 -10.3762 -3.21686 -5.77572 -470 2 4.63631 17.985 11.8048 7.12888 1.45886 -5.61107 -471 2 4.69408 18.0516 10.2533 5.93648 2.65605 9.16476 -472 1 7.56507 17.5919 1.8299 2.38736 9.59194 1.23507 -473 2 7.95273 16.7967 1.45285 -6.05148 -1.8022 -9.76241 -474 2 7.59068 18.2848 1.14776 -2.89899 -11.2976 1.8216 -475 1 1.88529 12.921 13.6059 -1.54804 -3.98178 5.6231 -476 2 1.43748 12.3178 14.2147 5.26513 0.934067 -3.79148 -477 2 2.14524 13.6768 14.146 -0.717118 1.88599 -5.70238 -478 1 9.71545 6.78651 14.8047 -15.2171 15.1422 7.50698 -479 2 9.90531 5.90708 15.1331 4.86835 -12.5985 -3.10865 -480 2 10.0627 6.91606 13.92 3.16992 -4.80507 -4.41639 -481 1 15.2317 4.3547 10.7806 -19.2619 -13.8042 -17.3299 -482 2 16.1692 4.17769 10.7161 9.63774 3.67614 12.8518 -483 2 15.0389 5.06132 11.3962 11.3469 5.0749 6.12787 -484 1 11.2086 6.13697 0.180528 -13.4008 -14.4307 -10.9666 -485 2 11.2654 5.18187 0.0337896 12.1183 5.06406 4.26486 -486 2 10.2799 6.29806 18.6081 2.85376 11.1709 5.84358 -487 1 0.155975 11.3317 15.1259 -12.2739 12.4049 -22.3111 -488 2 18.2869 11.6878 14.3448 9.29886 -6.35489 23.8975 -489 2 18.7388 12.0248 15.8046 -8.78344 -4.02614 -5.34871 -490 1 7.07225 9.17108 7.27057 -4.95781 3.28344 -6.42365 -491 2 6.44778 8.45946 7.46529 5.34767 -0.253084 5.87629 -492 2 7.94637 8.76128 7.25029 -3.14507 0.531691 2.27088 -493 1 18.4147 15.4309 12.3592 -5.86353 -0.606553 -5.09086 -494 2 0.72281 15.5186 12.2612 4.29187 -2.85716 2.67478 -495 2 18.0791 15.7216 11.5043 -3.32345 0.421348 1.66841 -496 1 16.5543 4.36503 5.23509 20.0373 -2.39618 26.5758 -497 2 16.7455 4.21973 6.1845 -16.121 -2.23612 -11.2684 -498 2 17.4558 4.42117 4.89188 -6.1573 5.26009 -14.9538 -499 1 17.766 3.07261 10.7271 -5.62269 10.8805 -1.85707 -500 2 0.0408353 3.2985 10.945 -3.12308 -7.03453 -2.35326 -501 2 17.719 2.23067 10.252 6.41295 1.44898 4.1666 -502 1 12.3026 0.0397215 10.1517 -5.9029 17.7484 6.25384 -503 2 11.458 0.404705 10.4688 2.82225 -9.87605 -6.68676 -504 2 12.8944 0.808865 10.1781 1.22751 -9.09827 -0.112681 -505 1 10.357 9.81077 12.3435 10.1956 0.0137966 -0.104503 -506 2 11.132 9.85287 12.9219 -4.83247 1.57396 1.64677 -507 2 10.2731 8.87192 12.148 -4.78867 -1.2901 1.32484 -508 1 0.505846 2.83821 7.01562 3.91094 -2.13436 13.3247 -509 2 0.681162 3.5182 7.67504 1.89272 4.99945 -7.1411 -510 2 0.694039 2.0503 7.53478 0.801338 -5.04329 -7.26695 -511 1 0.437103 15.2686 6.90942 10.3075 -26.8847 6.28938 -512 2 0.575652 15.2733 7.87231 -4.50905 3.86257 -7.07916 -513 2 0.764375 14.3681 6.66626 -11.1886 22.2654 -1.84191 -514 1 16.9895 7.01682 15.3107 -21.8777 2.45652 -5.46979 -515 2 17.7216 7.6089 15.1142 9.4824 -7.00642 -0.959024 -516 2 17.2645 6.09907 15.4073 14.9833 2.67634 2.96399 -517 1 9.01274 12.4171 8.12853 10.6441 15.1284 15.6095 -518 2 9.41612 11.8292 7.47716 -12.8498 -4.61215 -9.56742 -519 2 8.05003 12.5053 8.0704 6.97129 -9.84551 -10.1137 -520 1 1.26391 1.92336 3.04659 2.32337 -11.3487 -0.982019 -521 2 0.972058 2.42084 2.27545 2.43588 3.35199 3.68236 -522 2 1.90572 2.43981 3.5544 -5.46738 3.49891 -6.33947 -523 1 4.13143 15.1122 9.67174 -10.3949 2.47722 13.8895 -524 2 4.06276 15.2642 8.72313 5.39511 -1.60046 -0.0768584 -525 2 4.99495 14.7433 9.87874 3.88633 -1.07729 -6.21534 -526 1 7.19145 2.18155 14.5787 4.86443 0.520714 0.489557 -527 2 6.89453 1.81445 13.7426 1.87671 -5.23084 1.53267 -528 2 7.73681 2.92919 14.317 0.289792 2.5421 2.67041 -529 1 18.6 14.6947 2.16091 -2.26171 3.41683 0.482467 -530 2 0.820032 15.117 2.19003 5.03273 -5.31768 -1.38278 -531 2 17.9827 15.4314 2.17519 -7.65677 -2.44766 2.74205 -532 1 9.95161 2.77613 12.9401 9.45852 -1.28953 0.462065 -533 2 9.84872 2.18467 12.1812 -5.82301 1.90383 1.05008 -534 2 9.27924 3.46642 12.8986 -6.28602 -3.28272 -2.83121 -535 1 2.83159 8.92314 13.0298 -5.32883 -6.03653 -2.71455 -536 2 3.23927 9.77312 12.842 3.02047 6.8466 -0.359778 -537 2 3.51958 8.34046 13.3637 5.40811 -1.61307 4.23789 -538 1 3.22435 8.37789 3.65229 -1.03338 2.31116 19.4552 -539 2 3.68753 9.01983 3.09696 -0.346577 4.63804 7.35474 -540 2 3.38788 8.57936 4.60408 0.951973 1.27409 -22.7571 -541 1 5.6137 7.19416 8.52025 7.21613 5.80474 -6.44533 -542 2 5.78863 6.24316 8.52523 -9.99458 0.454093 3.85202 -543 2 5.0179 7.43184 9.24037 0.527922 -7.72891 3.36669 -544 1 14.8805 1.29251 2.00129 6.0675 21.6566 -5.88084 -545 2 14.8065 2.10545 2.50153 -6.7285 -1.94379 16.9269 -546 2 15.1655 1.66296 1.16284 -0.437229 -14.9075 -12.229 -547 1 8.26451 15.1933 0.836486 3.22704 -2.0235 12.9462 -548 2 8.92324 15.2163 1.54184 12.9519 -3.35665 -8.03315 -549 2 7.55879 14.6837 1.25205 -6.95241 0.364363 -7.46808 -550 1 15.625 1.34415 7.23495 -17.3283 -0.11068 -5.87671 -551 2 14.9596 0.769214 6.81661 10.6011 2.38946 3.65492 -552 2 15.1493 2.17629 7.38417 4.13791 -2.68619 2.35471 -553 1 4.93041 13.0764 18.5264 9.84655 1.48115 -2.02825 -554 2 5.35318 13.1968 0.744685 -3.49153 -1.64799 -2.34468 -555 2 5.56664 13.4414 17.8965 -2.33559 -1.35641 1.38511 -556 1 15.3557 8.48379 18.1448 0.204246 14.4785 -5.82183 -557 2 15.7265 9.09289 17.4831 -0.830936 -8.68367 1.885 -558 2 15.168 9.07051 0.245745 1.7123 -4.50429 2.39894 -559 1 12.0892 3.02993 18.3645 -15.9576 34.4498 -4.49703 -560 2 11.9769 2.60431 0.571005 13.6468 -16.1673 -1.05926 -561 2 12.5269 2.48004 17.7153 4.47893 -15.6345 5.41851 -562 1 13.2117 12.674 5.1931 -10.339 11.1011 -13.5125 -563 2 13.668 11.9204 4.80624 6.1285 -2.92776 7.79567 -564 2 13.4681 12.7869 6.11335 2.67539 -7.97004 0.458585 -565 1 6.0506 7.06933 0.0406962 1.31452 -3.72946 4.6718 -566 2 6.04306 7.98784 18.9476 0.374235 14.6189 -4.65006 -567 2 5.24553 6.71887 0.435288 -0.866845 -3.58603 0.782556 -568 1 17.739 15.9899 15.0125 -12.5206 6.16285 -12.4036 -569 2 16.945 16.5161 15.03 -7.46495 5.1976 21.0221 -570 2 17.8264 15.955 14.0627 17.7161 -15.0875 -11.5838 -571 1 13.1794 1.00208 16.5735 3.37979 -5.34722 -6.70143 -572 2 14.139 0.860857 16.6169 -5.21536 -1.33728 6.50102 -573 2 12.8035 0.137283 16.3512 2.48828 2.22182 6.02943 -574 1 11.096 14.5828 7.22348 0.0189977 4.74793 7.83345 -575 2 10.4045 14.1614 7.73717 -8.54387 -1.14011 0.371667 -576 2 11.8979 14.1335 7.50232 3.58446 -6.30574 -4.63725 -577 1 17.5104 8.62105 2.08846 14.2737 4.97696 2.51664 -578 2 16.6904 8.42754 2.54903 -5.27316 -4.4343 -3.04137 -579 2 17.6167 7.98338 1.37729 -7.36397 -7.55614 -1.26172 -580 1 12.3515 7.96855 1.99107 6.37927 0.258975 7.77687 -581 2 12.1159 8.90068 1.90258 -3.43959 -5.51169 -5.98444 -582 2 11.9581 7.4701 1.26507 -2.67829 1.90847 0.988543 -583 1 11.8954 14.6159 10.3514 1.85125 4.19108 3.73581 -584 2 12.1615 13.856 9.81631 -7.50724 5.70574 2.33101 -585 2 10.9524 14.815 10.2079 9.27078 -9.38408 -0.682121 -586 1 6.88225 7.03081 15.6002 -4.063 -7.66118 -6.77733 -587 2 7.75096 7.17076 15.1857 -5.63662 2.89282 10.0227 -588 2 6.77779 7.6167 16.36 6.70206 0.515961 -5.66863 -589 1 8.00078 4.70171 13.472 -1.59283 -4.83357 -4.64481 -590 2 7.27623 4.81783 12.8396 5.32657 -1.99722 0.885811 -591 2 8.48998 5.527 13.4768 -0.383179 2.4117 0.469228 -592 1 13.3975 12.1709 14.2706 1.21587 3.44049 5.53322 -593 2 13.2724 11.2098 14.2197 -1.68144 4.93388 -3.39254 -594 2 13.8611 12.4606 13.4725 -0.646036 -5.76058 -0.123004 -595 1 14.8166 9.4384 7.29692 -7.31149 -4.84482 -6.71483 -596 2 15.6063 9.98387 7.39943 -3.2576 1.32409 4.65546 -597 2 14.0612 9.86586 7.70853 4.31514 4.68737 1.52589 -598 1 12.6657 17.0265 3.08863 -0.499632 18.4226 10.5493 -599 2 13.0409 17.4141 3.89779 -4.03665 -9.69042 -5.1428 -600 2 12.0457 17.7132 2.78031 5.51866 -13.6109 -0.0343421 -601 1 1.16791 7.14337 17.4519 -17.3777 -0.471365 -9.17207 -602 2 0.285968 6.88879 17.7816 4.71885 8.57951 0.206219 -603 2 0.996987 7.64547 16.6337 5.09703 -7.79381 5.85561 -604 1 12.7928 5.13809 15.6672 21.9233 -6.79759 1.12632 -605 2 13.5314 4.49934 15.6812 -12.3388 3.06691 0.377185 -606 2 13.2535 5.99313 15.6546 -7.1176 -2.71451 -0.771614 -607 1 2.50804 3.40102 5.01245 -9.19737 1.42964 37.6951 -608 2 1.85734 3.08405 5.69632 14.2768 7.06331 -19.9109 -609 2 3.04485 4.07021 5.49582 -10.9118 -9.07044 -17.2872 -610 1 8.33238 11.2579 13.4651 -31.1482 13.4197 6.60268 -611 2 8.24927 11.0816 14.4232 19.8118 -8.42601 -14.5581 -612 2 9.11403 10.9307 13.0113 5.91799 -11.9552 15.0186 -613 1 12.8978 1.37199 13.3367 -3.68795 11.8567 -21.2004 -614 2 13.3586 1.33808 12.4821 5.12584 -5.42725 10.3839 -615 2 12.3812 2.18266 13.2296 0.582289 -3.8456 10.447 -616 1 6.35916 13.6786 2.13932 11.022 -2.36774 12.7417 -617 2 5.81416 14.065 2.83164 -5.92624 2.48265 -4.44044 -618 2 6.97105 13.1303 2.64934 1.90703 -2.61302 -7.4669 -619 1 15.9256 6.59608 12.7788 -4.50753 -7.00075 -5.11208 -620 2 16.441 7.14613 12.1828 -0.0403293 3.27533 -1.15613 -621 2 16.337 6.66123 13.6439 3.64448 2.92523 3.21919 -622 1 16.8436 0.710185 9.59384 -10.8386 -3.59173 0.641976 -623 2 16.678 18.424 9.8391 7.1202 6.86076 -6.23598 -624 2 16.34 0.863872 8.77611 6.63769 -2.37412 0.960785 -625 1 6.14874 11.7365 8.37914 -9.33508 -33.9533 -7.34454 -626 2 5.23473 11.5355 8.67103 13.3879 7.28881 -1.35634 -627 2 6.50048 10.8558 8.08418 -3.72877 24.3898 8.07481 -628 1 2.86629 8.64627 0.414665 29.1459 -9.93647 1.24251 -629 2 2.37091 8.1673 18.3782 -14.09 11.8062 8.4924 -630 2 2.39345 9.32329 0.907466 -18.2396 -1.77699 -9.50941 -631 1 10.1496 10.4602 6.51654 2.68196 -4.3054 1.18084 -632 2 10.6351 9.79475 7.02051 -3.21697 0.687034 0.899044 -633 2 10.5797 10.4719 5.65285 -1.94715 4.18574 1.72512 -634 1 6.74842 15.6916 6.55665 -2.66838 16.8954 6.36263 -635 2 7.13132 16.1354 7.32023 -0.325366 -7.45035 4.57015 -636 2 6.8063 16.3799 5.88394 5.31174 -8.689 -7.83261 -637 1 6.45137 13.1469 5.60457 -4.49761 -5.86725 0.527716 -638 2 6.60666 13.9979 6.03098 2.95924 -2.27328 1.19215 -639 2 5.97977 12.5923 6.23705 2.74812 2.58161 1.74453 -640 1 16.8067 12.5538 9.81832 0.32671 -4.80998 5.18546 -641 2 16.9975 11.894 9.13199 -1.38663 9.72579 -2.40586 -642 2 16.8023 13.4365 9.43343 1.83869 -5.34542 -5.01893 -643 1 6.05747 2.94525 2.83457 1.69886 0.640591 -2.15275 -644 2 6.28227 3.83854 2.57267 5.15417 9.09864 3.82618 -645 2 5.67557 2.57416 2.03485 -2.61266 -9.3622 -0.552159 -646 1 10.8942 3.30264 3.28891 6.21412 -5.01644 3.41466 -647 2 10.2824 3.98758 3.58006 -2.01501 -0.119341 -5.67488 -648 2 10.543 2.90591 2.48434 -5.60317 1.35459 0.297545 -ITEM: TIMESTEP -30 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.7097 7.05343 17.9609 20.7509 -2.32452 -4.15205 -2 2 7.78893 6.94819 18.1674 -15.0431 -3.26874 3.90688 -3 2 8.91258 6.41114 17.2706 -4.14568 0.140094 0.745653 -4 1 18.6207 8.28878 6.84456 -10.9758 14.7568 -16.4597 -5 2 0.033254 8.12327 5.87995 7.78297 -6.3031 11.7942 -6 2 0.390602 7.58629 7.343 9.14113 -10.4614 1.3502 -7 1 8.4202 18.5906 6.81681 -12.3331 6.77681 2.70587 -8 2 9.32414 0.194792 6.65918 12.4366 2.53215 -2.1327 -9 2 7.89923 0.683074 6.46691 2.1768 -2.64942 -1.08929 -10 1 6.58134 1.82408 11.6823 -18.6778 6.99539 14.5251 -11 2 5.88329 2.28495 12.2086 12.5233 -11.9933 -14.8966 -12 2 6.20729 0.949756 11.4934 -0.484037 1.974 1.03676 -13 1 7.10261 5.71907 2.36398 18.2567 -30.46 4.77574 -14 2 6.748 6.26194 3.05915 -16.1408 13.0855 0.817955 -15 2 6.89353 6.07497 1.50557 -7.56713 14.4666 -6.71064 -16 1 16.2146 10.1912 16.1045 25.8326 -16.9059 -6.28167 -17 2 17.1924 10.2614 15.9892 -26.0275 4.96146 3.01812 -18 2 15.8649 11.0425 16.3511 -1.01593 12.6392 3.03555 -19 1 10.6309 14.9782 2.32852 5.54907 12.6484 -4.66534 -20 2 10.5683 14.607 3.21596 0.623447 -1.40903 0.430751 -21 2 11.0949 15.8303 2.43151 -6.58286 -12.6372 2.6945 -22 1 17.1592 8.25618 10.4876 -10.0218 -2.97818 8.46282 -23 2 16.7485 8.99843 10.9576 2.65758 -6.15573 0.24812 -24 2 17.9939 8.575 10.1448 6.84049 6.50961 -0.847785 -25 1 14.8275 15.8902 16.3678 -10.7483 8.55828 -7.5541 -26 2 13.911 16.2262 16.382 8.40977 -5.5752 2.0788 -27 2 14.9328 15.3229 17.136 -2.68587 0.983086 7.72287 -28 1 12.1445 13.398 0.450021 7.16446 -9.51802 2.88894 -29 2 12.0254 13.4023 18.1304 -4.57533 9.09159 6.34311 -30 2 11.5749 14.0284 0.911779 -3.72154 -0.858053 -5.79964 -31 1 9.27791 5.43254 4.03115 12.5872 2.27984 -15.9713 -32 2 8.88042 5.04351 4.80522 -11.7175 -1.93285 8.71688 -33 2 8.63164 5.36398 3.31053 -0.238489 1.95718 4.1093 -34 1 1.81582 4.23406 11.6392 3.52665 -33.0533 9.77708 -35 2 1.78778 5.15359 11.8657 -3.54286 18.5189 3.84305 -36 2 2.12638 3.75505 12.4373 -4.00166 7.6753 -17.1576 -37 1 1.99877 6.82017 8.35649 4.97761 -1.46296 10.7796 -38 2 2.31944 7.23424 9.17304 -0.0326511 4.09138 -10.3959 -39 2 2.07937 5.88268 8.56766 -7.36821 -1.33929 -3.79841 -40 1 5.395 4.41162 7.94446 4.05063 -3.43427 6.53634 -41 2 5.41133 3.44966 7.94196 6.73946 -4.4132 0.768998 -42 2 4.74595 4.62804 7.28165 -7.35272 12.6119 -8.90882 -43 1 3.28409 2.93052 17.527 4.91883 3.31559 -8.51102 -44 2 3.97895 3.44036 17.0791 -2.08356 -9.03714 -1.68785 -45 2 2.70652 3.59221 17.9099 -2.28402 5.9437 7.00724 -46 1 7.47067 5.28165 6.09824 -7.47353 5.76211 -2.63966 -47 2 7.88561 6.05707 6.46631 15.843 7.70036 2.30241 -48 2 6.86027 5.05727 6.79609 -9.98425 -16.5426 3.24835 -49 1 9.77462 7.02047 11.9927 -3.16333 0.34511 -3.92757 -50 2 10.3836 6.39122 11.588 -5.90607 3.51948 -2.51732 -51 2 9.0529 7.19715 11.3548 12.4276 -3.26368 6.69514 -52 1 14.0466 3.57679 8.07144 18.6703 -0.348541 19.5758 -53 2 13.8937 4.22019 7.39343 -5.64007 13.0869 -9.16622 -54 2 14.611 4.0279 8.7381 -15.3074 -10.3909 -10.441 -55 1 4.67183 17.2138 3.98342 -17.1629 -17.7927 10.2823 -56 2 5.57476 17.4036 4.21567 13.953 12.775 -5.74716 -57 2 4.34342 17.7474 3.25626 2.59666 4.69733 -2.98879 -58 1 16.5112 16.6016 10.1232 -22.4077 14.5184 19.5552 -59 2 15.797 16.9077 10.7255 16.9762 -11.2391 -6.18282 -60 2 16.019 16.127 9.45142 2.29692 -6.2585 -6.10264 -61 1 1.96965 4.87893 0.40906 -10.7697 -8.55226 -4.93465 -62 2 2.66061 5.27529 0.941341 5.5274 3.49831 6.88318 -63 2 1.47511 5.62215 18.6951 6.32177 2.44726 -2.78863 -64 1 11.7331 13.3335 16.3023 -6.06186 -8.167 -3.78825 -65 2 11.2597 12.4992 16.3612 -10.498 -1.32756 10.0093 -66 2 12.2577 13.1697 15.5177 8.21427 7.2284 -4.69488 -67 1 10.121 11.0486 16.9167 -7.88764 10.2638 -1.90592 -68 2 10.5124 10.1783 16.9786 2.49636 -9.86729 -0.127492 -69 2 9.16626 10.9164 16.816 6.71354 -1.99355 -1.80005 -70 1 11.7161 17.4964 13.4564 0.653858 7.10726 11.4031 -71 2 12.4343 17.1488 12.9211 3.60089 1.57548 -4.57497 -72 2 11.8646 18.4589 13.5472 2.97554 -11.89 -7.13537 -73 1 6.3779 9.31416 12.2259 -8.95234 15.1635 22.3379 -74 2 6.77463 8.98312 11.4273 14.2971 -1.19702 -8.86117 -75 2 6.96666 9.97806 12.6372 -2.9053 -11.0825 -10.5803 -76 1 16.2282 12.7644 2.6938 13.255 22.6007 -2.42149 -77 2 17.0484 13.1981 2.39924 -4.54016 -10.6437 3.48813 -78 2 15.6471 13.522 2.85837 -6.5992 -7.46489 -1.32569 -79 1 0.640508 12.5852 5.88727 21.753 -1.83143 4.54161 -80 2 0.997304 12.3975 5.01963 2.04371 1.22983 -7.11515 -81 2 18.3646 12.7399 5.72186 -19.0302 3.73655 0.683884 -82 1 5.21387 16.4194 18.454 4.66732 -1.11443 8.72996 -83 2 5.89359 15.806 18.1817 0.824082 -8.56943 -13.0935 -84 2 5.59435 16.7978 0.603858 -5.48698 7.00748 3.62952 -85 1 0.548987 7.64401 4.10842 0.670348 4.32997 2.73018 -86 2 18.6015 7.92625 3.40384 -3.24873 3.72744 -1.92559 -87 2 1.36738 8.12724 3.94642 3.53853 -5.18785 -2.83474 -88 1 3.12734 8.93117 6.50347 30.4123 1.43415 3.20415 -89 2 3.68489 8.55498 7.21169 -11.4249 4.27745 -10.9708 -90 2 2.23185 8.74841 6.74202 -19.2185 -4.73256 7.28786 -91 1 7.31515 10.3274 16.2171 -7.5998 2.86538 3.08356 -92 2 6.58991 10.5191 15.6248 2.07633 0.375924 -7.53004 -93 2 6.86928 10.3012 17.0718 3.58834 -2.41696 5.50844 -94 1 11.1056 1.03439 5.00906 5.66297 2.87297 -9.25474 -95 2 11.3082 1.81468 4.47889 -2.42802 6.95123 8.17266 -96 2 10.7866 0.43271 4.33294 -5.36858 -10.0003 1.63315 -97 1 4.38851 2.75082 13.2055 -1.16421 16.6802 -23.4007 -98 2 4.78143 3.22961 13.9394 0.315345 -9.27332 13.6616 -99 2 4.20912 1.83275 13.4212 4.21877 -6.70893 11.8835 -100 1 8.39225 10.0828 1.81263 -0.204034 19.0364 -5.60934 -101 2 8.35289 10.7959 2.47026 -1.38438 -3.08289 -2.87504 -102 2 8.81547 9.35618 2.25702 3.41266 -13.1645 6.66357 -103 1 10.4926 1.73671 15.571 11.1439 -7.64614 -12.2914 -104 2 11.3949 1.40928 15.4244 -6.59208 6.73213 11.009 -105 2 10.2461 2.06593 14.699 -6.9068 1.71228 -0.826453 -106 1 2.72763 12.9186 7.78215 1.53907 -1.41162 9.17357 -107 2 3.36352 13.5565 7.43734 -3.21302 -0.65885 -4.12251 -108 2 2.22004 12.5809 7.03913 -2.76352 5.50699 -3.09439 -109 1 3.68558 11.672 5.21041 4.08504 4.36046 -3.38247 -110 2 3.45481 10.9554 5.79468 0.598863 -9.40064 6.30918 -111 2 2.92113 11.7973 4.6466 -2.33635 3.52119 -7.07475 -112 1 6.80415 14.4796 16.8864 5.34146 -11.2852 2.95693 -113 2 7.68462 14.091 16.8709 -3.70601 4.15103 0.993665 -114 2 6.49099 14.4407 15.9783 -2.62919 9.78665 -2.68056 -115 1 14.176 14.5561 3.39307 -12.5209 -3.15767 3.59597 -116 2 13.6245 15.3467 3.3085 5.15733 -4.43597 -5.06132 -117 2 13.635 13.92 3.89178 10.6994 6.10439 -0.0738324 -118 1 8.31018 18.1523 16.0453 25.0942 2.73084 1.98444 -119 2 8.89462 17.4796 16.3723 -6.95894 -25.3404 9.38217 -120 2 8.98968 0.119946 15.7574 -11.3153 21.4924 -7.69748 -121 1 4.73581 1.63729 4.92804 -12.581 -10.4736 11.5054 -122 2 3.83953 1.97889 4.8343 1.42607 1.89675 3.67103 -123 2 5.27039 2.18299 4.37483 11.2234 12.2757 -18.577 -124 1 15.0504 12.7475 16.4383 22.4341 -19.9388 -26.396 -125 2 14.708 13.1949 17.1966 -19.6268 9.49299 12.0559 -126 2 14.4413 12.6723 15.6738 0.429593 5.89098 19.3668 -127 1 15.7794 18.4162 16.8297 -23.8108 0.224717 -24.365 -128 2 16.2557 18.6157 17.6209 13.9809 -1.68 17.1984 -129 2 15.4229 17.5182 16.8969 9.44127 2.10519 2.83182 -130 1 1.1656 1.1613 16.5455 9.88565 -3.33075 -8.05438 -131 2 1.89055 1.78579 16.6066 9.02992 -0.102422 -1.61706 -132 2 0.673214 1.35844 17.3295 -13.4515 3.62078 11.8035 -133 1 18.1028 4.54571 15.8941 -4.73113 6.48399 7.96005 -134 2 18.5013 4.04336 15.196 5.27298 -10.1152 -10.2677 -135 2 18.7433 4.58481 16.606 1.22293 0.259147 -1.01212 -136 1 12.236 16.9836 16.146 14.9412 3.5391 -27.9779 -137 2 11.6416 16.3841 16.5672 -17.548 -8.54782 13.2608 -138 2 12.0887 16.8479 15.1863 -0.907912 9.23395 13.7712 -139 1 15.9498 2.53257 18.0253 10.6473 -13.6828 8.83411 -140 2 15.5627 3.24781 18.526 -5.22656 12.7326 -1.10284 -141 2 15.751 2.68965 17.0989 -3.04742 3.76351 -4.61681 -142 1 6.7038 13.8197 10.2271 2.9338 -17.2727 -3.34939 -143 2 6.61667 13.5512 11.144 -2.24755 5.72821 7.93099 -144 2 6.68776 12.9653 9.76874 -1.43812 10.35 -6.56898 -145 1 10.1318 18.2649 2.7724 -13.411 -9.16786 2.85058 -146 2 10.3828 0.244178 2.09267 2.54842 10.4954 -6.81354 -147 2 9.19143 18.056 2.59362 16.7762 1.59207 3.74676 -148 1 2.99108 17.7409 6.10283 23.0954 -1.76337 16.2177 -149 2 2.19234 17.7622 5.58671 -8.31269 -3.84851 -15.8536 -150 2 3.76803 17.7869 5.51609 -16.1123 2.00349 -4.76697 -151 1 12.5756 16.9274 7.99763 -5.18448 9.92793 0.0594024 -152 2 11.7822 16.4009 7.94219 -1.30832 -15.7704 -9.09049 -153 2 12.3073 17.5896 8.63909 10.7698 6.45321 6.22995 -154 1 14.8838 15.2691 8.24901 11.9288 7.15592 -19.4456 -155 2 14.3219 16.0313 8.11935 -17.9047 1.82161 10.6012 -156 2 15.419 15.3185 7.43747 0.964457 -9.38205 7.76842 -157 1 17.6242 18.2515 0.369787 17.475 26.3316 2.73311 -158 2 18.5101 17.9713 0.0958777 -8.0951 -12.2782 0.813683 -159 2 17.7821 0.518901 0.686034 -9.22006 -13.9572 -3.22273 -160 1 0.867554 10.3913 1.38534 13.3292 31.3771 -20.1166 -161 2 0.0708789 9.90853 1.49908 -23.2341 -17.8443 11.3974 -162 2 0.609768 11.125 0.785047 6.92113 -8.95227 10.8017 -163 1 1.63658 12.2225 3.36866 -7.99561 -17.8946 -31.9552 -164 2 1.35203 11.5128 2.74742 7.334 6.03534 21.6261 -165 2 1.63695 12.9742 2.77054 4.15295 9.67724 10.1418 -166 1 0.571199 17.2371 4.87124 -14.5407 6.59112 32.0774 -167 2 -0.059088 17.9662 4.92138 6.12201 4.50556 -13.0577 -168 2 0.445901 16.8548 5.75927 11.2459 -10.7393 -14.745 -169 1 1.10756 0.954018 9.42478 -6.01064 0.927768 -12.2971 -170 2 1.20282 0.614567 10.324 -1.80966 -3.76099 -1.37067 -171 2 0.239583 0.659806 9.09473 9.24115 0.27684 10.6776 -172 1 16.7657 2.33783 13.2856 -4.77092 -12.7415 18.4331 -173 2 16.9235 2.53629 12.3736 4.43968 6.32108 -18.3535 -174 2 16.5017 1.40258 13.3145 0.84997 6.98888 1.09187 -175 1 2.55595 15.84 12.1915 -9.99296 7.89206 -20.2214 -176 2 3.13585 15.4219 12.8083 9.49953 -6.79049 14.4751 -177 2 2.92245 15.6515 11.3148 -0.922807 -1.51117 1.32599 -178 1 16.4223 15.613 5.98575 -3.71667 -18.1819 11.7841 -179 2 17.3247 15.5921 6.33835 -0.216171 6.69275 -4.6749 -180 2 16.2529 16.4332 5.52058 8.23488 6.69239 -4.77655 -181 1 5.80627 5.05529 11.7835 2.20346 1.03406 8.57972 -182 2 5.47099 5.61389 12.5063 0.21977 1.29573 -10.4635 -183 2 5.43215 4.18052 11.9366 -3.48089 3.11082 -1.53573 -184 1 15.1897 4.8564 0.727292 -5.49239 9.65996 -2.72664 -185 2 15.2051 4.71263 1.67299 -4.1535 -7.09946 8.01526 -186 2 14.3467 5.30742 19.2217 7.5675 -5.77492 -4.69919 -187 1 16.3443 16.3423 2.09898 -10.6702 -0.501744 21.7899 -188 2 16.0343 16.7391 2.94116 7.72577 -10.997 -12.8868 -189 2 16.4832 17.1019 1.54751 7.961 8.6491 -12.4493 -190 1 0.271558 4.86315 3.80356 2.16636 -31.8967 4.70784 -191 2 0.500225 5.77685 3.71679 7.2244 19.9811 4.59738 -192 2 1.02077 4.40389 4.23265 -9.838 12.5034 -4.93629 -193 1 2.94659 15.0442 15.0679 0.642608 -6.50925 -4.27186 -194 2 2.75789 14.5701 15.8868 0.637625 5.4096 6.54553 -195 2 2.48063 15.8876 15.1248 -0.665005 -3.22304 2.52721 -196 1 1.13823 14.625 9.55769 -40.6641 2.98648 23.3687 -197 2 1.89308 14.4183 9.03602 24.2615 -17.8348 -5.78778 -198 2 0.899054 13.8694 10.146 16.149 11.9497 -18.7143 -199 1 13.6328 16.6228 11.5317 -8.77554 -4.828 10.6654 -200 2 13.2136 17.4084 11.1616 -1.58446 0.630618 -8.00902 -201 2 13.0391 15.8864 11.302 7.59245 3.60181 -7.14688 -202 1 4.70114 1.47286 0.734685 -3.14847 1.30924 1.42089 -203 2 4.10181 2.05657 0.255283 4.3012 0.912352 -3.9516 -204 2 4.12143 0.893804 1.23429 -1.01367 -7.44934 0.356301 -205 1 1.44259 18.5254 11.8725 4.87725 -20.5249 2.38925 -206 2 1.2982 0.329643 12.7089 -1.92821 4.76162 2.3937 -207 2 1.66413 17.5975 12.0994 -0.659414 17.7173 -3.45023 -208 1 11.5206 10.1171 4.06393 -3.80452 1.00663 -6.51606 -209 2 11.2843 10.553 3.23019 1.0155 -1.19537 2.23558 -210 2 12.4827 10.1039 4.08159 3.36054 1.41703 2.51077 -211 1 8.33991 12.1729 3.71569 5.40649 2.32091 -9.4304 -212 2 9.08268 12.7024 4.00206 12.7546 1.78956 -5.29094 -213 2 7.80528 12.1916 4.49536 -21.4073 -3.06625 11.8611 -214 1 14.3677 4.01314 3.28101 5.46562 4.88363 2.56432 -215 2 15.0857 4.19963 3.89805 0.543674 -3.28085 4.74869 -216 2 13.622 4.5498 3.58084 0.572713 -1.66955 -3.63784 -217 1 5.59145 1.71061 7.51389 3.0333 8.44076 -17.8773 -218 2 4.93757 1.09228 7.83941 -4.88752 -5.30351 6.58254 -219 2 5.37448 1.80426 6.56172 4.34195 -4.37145 14.4788 -220 1 17.8887 1.09435 4.8754 -0.773263 0.600717 5.02725 -221 2 18.623 1.41887 4.35928 5.70444 0.114988 -11.5441 -222 2 17.8389 1.7231 5.59879 -7.43418 -0.321368 4.00301 -223 1 6.81825 9.41317 4.48156 7.11204 -1.13267 15.9283 -224 2 6.84118 9.52277 5.44603 -5.88151 0.934362 -6.29355 -225 2 7.74851 9.26985 4.27279 -2.06614 -3.64671 -7.13223 -226 1 2.66566 14.925 1.97184 3.43761 -5.8072 22.4208 -227 2 3.31024 14.6851 2.65976 -11.6222 2.95672 -3.26291 -228 2 3.19272 14.9753 1.1906 5.92571 0.162325 -19.2981 -229 1 17.2917 12.9099 13.1468 13.6904 -32.8575 1.82925 -230 2 16.4305 13.254 13.3667 -5.78742 18.0954 -2.54799 -231 2 17.8833 13.5932 12.8229 -8.84805 15.1913 2.15275 -232 1 14.9839 10.5629 1.38454 25.7264 11.2091 10.263 -233 2 15.6084 11.2587 1.71974 -19.4135 -18.6888 -7.72567 -234 2 14.1549 11.0026 1.25075 -10.8149 6.915 -1.22185 -235 1 5.70372 6.84607 4.55662 8.80438 8.80025 -0.823305 -236 2 6.10735 7.7373 4.58073 -7.50282 -10.5851 -1.04914 -237 2 6.32636 6.24858 4.99 1.7616 -0.154003 4.43374 -238 1 8.04871 8.29405 10.2754 3.94684 3.34606 -22.4081 -239 2 8.71637 8.94856 10.0317 -1.03323 4.34225 9.84614 -240 2 7.78699 7.97842 9.39774 -4.16124 -6.72066 12.7971 -241 1 13.4913 18.3469 5.77892 -1.26098 13.9384 -13.7404 -242 2 12.815 0.368504 5.57583 1.14564 -3.93427 -2.76608 -243 2 13.0908 17.8361 6.47463 -1.65231 -11.4802 12.6171 -244 1 0.227007 2.59645 0.141675 -14.0496 12.7254 8.33212 -245 2 17.9751 2.93781 18.665 -4.73692 -13.8452 -6.2234 -246 2 0.694599 3.38298 0.431909 14.3746 0.669884 0.426623 -247 1 12.7219 11.0238 9.75183 49.8657 -12.692 14.413 -248 2 11.8223 11.0616 9.49871 -31.5247 -8.5727 -6.88909 -249 2 12.9406 10.0926 10.0008 -12.7634 16.4478 -4.29644 -250 1 0.765495 12.2256 11.092 -6.27201 -3.92882 -21.6672 -251 2 18.4439 12.3344 11.0429 5.26844 -2.50397 8.5312 -252 2 1.08097 12.384 11.9788 -3.27397 5.59862 9.72518 -253 1 5.06534 7.27352 13.4491 9.82463 3.8805 6.07585 -254 2 5.60445 7.97165 13.048 -4.44492 -2.76176 -4.56894 -255 2 5.50693 7.14172 14.2991 -3.01503 -3.24863 -0.495805 -256 1 1.24722 6.90803 11.85 29.2977 26.916 27.8288 -257 2 0.522094 7.24638 11.3513 -16.2758 4.78156 -11.2742 -258 2 1.67283 7.72942 12.2344 -11.891 -29.9717 -16.3043 -259 1 15.4903 9.51892 12.3126 7.40517 -6.095 -16.4028 -260 2 15.1231 10.4002 12.2744 -2.67202 9.46709 6.64342 -261 2 15.3464 9.12903 13.1709 -3.09066 3.82816 8.99587 -262 1 16.6298 12.8631 5.48891 1.11523 -3.92575 5.75418 -263 2 16.4995 13.8048 5.46845 -2.55881 16.2829 11.3267 -264 2 16.4805 12.6501 4.57692 -1.87933 -15.1854 -15.6508 -265 1 6.21094 9.97472 0.0957231 23.6487 -5.34392 2.82943 -266 2 5.60453 10.4038 0.703481 -3.26342 3.61778 2.3496 -267 2 7.09538 10.0231 0.521798 -18.1891 -1.30215 -0.820391 -268 1 12.348 6.08762 4.05307 2.0614 24.7942 -10.4953 -269 2 12.1492 6.85087 3.46448 11.8353 -14.4305 6.54315 -270 2 11.534 5.60454 4.05688 -13.4451 -11.2489 2.03158 -271 1 0.182227 12.8112 0.197519 7.97213 -0.157956 2.72486 -272 2 0.124577 13.5143 0.856815 -1.71897 -0.134619 0.137441 -273 2 18.3975 13.1734 18.0617 -3.09196 -0.84285 -5.0356 -274 1 3.77998 18.5905 8.57799 -18.8802 5.92516 7.26956 -275 2 3.52251 17.9827 7.88131 5.13558 -0.560148 -6.56591 -276 2 2.92387 0.359522 8.79319 10.0752 -0.462424 4.43469 -277 1 7.44275 17.2901 4.46744 -21.5086 -34.4409 7.51913 -278 2 7.83961 18.0981 4.73248 10.1677 27.4444 -0.194329 -279 2 7.33826 17.2675 3.51576 6.23588 9.30645 -6.08156 -280 1 9.24103 17.0711 12.2479 -19.3743 11.7076 -0.715804 -281 2 9.17102 16.3949 11.5719 7.91635 -8.00505 -0.934966 -282 2 10.0835 16.9964 12.6894 10.2718 -1.4174 0.528472 -283 1 13.295 12.9281 7.96455 10.8524 35.2373 8.53109 -284 2 13.4175 12.2933 8.66577 -5.31299 -13.0614 2.94334 -285 2 13.7676 13.7325 8.27776 -0.249345 -13.5851 -11.5496 -286 1 14.9473 2.96516 15.3472 -8.56764 -6.90335 7.41648 -287 2 14.4704 2.13858 15.1989 -5.86972 7.46703 2.11397 -288 2 15.5773 2.99488 14.6333 9.67131 3.29159 -8.66831 -289 1 9.8733 15.5399 16.9999 -1.15808 -3.26391 2.43146 -290 2 10.4067 14.7753 16.7398 -3.17357 -1.97936 0.56939 -291 2 9.29049 15.2638 17.7267 6.50431 4.19029 -1.43758 -292 1 11.3155 8.30103 16.5489 -8.97523 -12.184 6.64215 -293 2 10.5995 7.86385 16.0596 7.08532 7.34183 -0.412451 -294 2 11.4953 7.67267 17.2664 2.19784 9.25982 -2.90547 -295 1 3.86136 18.202 16.7472 -0.00540616 -19.6914 -20.2162 -296 2 4.27115 17.4628 17.2262 -1.12743 11.6131 4.05136 -297 2 3.85436 0.333712 17.2887 2.36829 10.2975 15.3313 -298 1 2.18996 4.14488 8.93819 0.886129 3.08448 -7.12661 -299 2 3.10445 4.02058 8.72725 13.9566 -1.85365 -12.2229 -300 2 2.19804 3.9794 9.87086 -10.6985 1.40109 20.9797 -301 1 9.87077 10.3617 9.71962 10.1113 -1.13074 11.4426 -302 2 9.57245 11.1887 9.34333 -7.01747 6.00246 -6.1834 -303 2 10.1269 10.5679 10.6319 -2.96085 -6.85282 -1.29137 -304 1 9.72151 0.827202 10.8565 -16.8019 0.79505 -1.6906 -305 2 9.17924 18.7332 11.1654 13.4836 -3.87865 6.80866 -306 2 9.14124 1.21724 10.1941 6.30814 7.82285 -3.72399 -307 1 9.21217 15.15 10.2242 6.46373 1.33184 2.55262 -308 2 8.76537 15.794 9.67699 -2.80645 8.81337 -5.09524 -309 2 8.53339 14.5081 10.4276 -6.91387 -6.36492 -2.48134 -310 1 0.979873 9.39617 10.3168 -32.1534 32.2854 2.26584 -311 2 1.01417 10.3672 10.3328 -11.1793 -7.1298 6.70775 -312 2 1.8685 9.20872 10.1515 40.6499 -19.8378 -9.87175 -313 1 16.9127 4.85919 8.18774 -4.59801 12.0977 -12.3954 -314 2 16.2737 5.53573 8.4435 0.928859 1.2732 2.05393 -315 2 16.9639 4.27263 8.93179 4.52425 -11.0836 8.47724 -316 1 14.6737 14.709 0.318185 15.3338 2.15239 -13.9805 -317 2 15.2295 14.9726 1.0606 -1.701 5.56475 -1.20644 -318 2 13.8551 14.4222 0.702232 -12.5496 -7.63291 5.74768 -319 1 3.57822 11.0521 9.58832 7.05767 -0.848593 3.86503 -320 2 3.70772 11.5491 10.4084 -2.82358 -5.49605 1.13538 -321 2 3.0796 11.6369 9.01245 -0.492053 5.16034 -4.32733 -322 1 11.1043 10.8166 1.33994 -11.5702 -13.9866 8.70354 -323 2 11.3928 11.6085 0.903197 7.06397 14.5046 -5.44138 -324 2 10.1649 10.7312 1.10986 7.36828 -2.13735 3.91294 -325 1 13.1846 7.09882 12.8318 18.6724 6.28095 -0.937746 -326 2 14.1536 6.98642 12.9472 -16.4658 1.64828 -3.93553 -327 2 12.8311 6.20921 12.7949 -4.05904 -6.33012 1.01947 -328 1 9.62724 1.89857 0.976269 -5.84048 -4.71512 -19.854 -329 2 8.85605 1.47112 0.556627 5.981 10.7585 7.84687 -330 2 10.1714 2.22507 0.238723 -1.51496 -2.73206 9.47681 -331 1 10.5937 13.5214 4.66199 3.2234 0.0339744 -7.62843 -332 2 11.4486 13.114 4.51461 3.39436 -8.72009 -0.849353 -333 2 10.7191 13.8974 5.52846 -5.55452 9.94363 9.85641 -334 1 14.3279 1.73837 10.9221 -6.80645 -20.6925 1.76137 -335 2 15.1234 1.41881 10.4767 1.97621 6.90305 1.731 -336 2 14.3743 2.69243 10.9875 9.24527 6.91542 -4.56959 -337 1 14.6348 12.3447 11.7069 0.143663 -8.85162 -7.69369 -338 2 15.3924 12.4169 11.1267 15.8185 6.23005 6.53749 -339 2 13.9779 12.0599 11.0796 -19.2308 -4.32411 1.56042 -340 1 8.24345 5.06862 9.81236 -2.43519 -19.796 -15.4196 -341 2 7.42328 5.28077 10.2334 -12.2119 11.2175 13.6651 -342 2 8.03366 4.19231 9.43495 14.0834 8.03075 2.78805 -343 1 1.55958 16.8456 18.3509 0.293915 -24.903 24.1992 -344 2 1.74487 17.2231 17.5072 8.4457 6.47265 -18.7434 -345 2 1.95964 15.9468 18.3277 -12.6492 15.8955 -3.16542 -346 1 1.46885 17.2295 15.3261 -41.9231 18.9429 7.61422 -347 2 1.60163 18.0716 15.7975 2.88525 -7.29411 -7.90761 -348 2 0.471438 17.1304 15.2829 39.2238 -5.53287 -0.382895 -349 1 3.69895 5.65007 6.13962 5.67498 -13.7905 -4.71311 -350 2 3.08621 6.15365 6.67268 -1.79156 10.6243 5.04455 -351 2 4.29662 6.26435 5.6935 -4.62364 1.91275 -0.121461 -352 1 12.3686 9.4572 14.1916 2.50325 4.1373 0.835901 -353 2 12.6534 8.64397 13.7789 7.43403 -8.19142 -7.10693 -354 2 12.2431 9.18714 15.1032 -3.68368 1.41273 6.14038 -355 1 4.03462 15.2828 6.91278 -20.0144 -6.90546 3.84648 -356 2 3.57361 16.022 6.48562 4.0204 -1.30953 4.99773 -357 2 4.97214 15.427 6.85986 17.0804 8.85667 -5.89205 -358 1 0.596937 8.57007 14.913 -2.82207 -2.34568 11.0967 -359 2 0.589839 9.51288 15.1099 0.171131 2.88226 -3.41975 -360 2 1.22453 8.45469 14.2015 6.96836 3.95738 -3.73783 -361 1 12.9772 8.31295 10.3135 -4.52981 3.4147 9.81026 -362 2 13.748 7.88649 9.95158 7.10588 -4.96512 -13.4998 -363 2 13.0418 8.05063 11.2408 -7.87478 3.04011 -0.538852 -364 1 15.3081 7.67138 3.5266 23.4653 37.2808 -10.5735 -365 2 14.5495 7.31548 3.08478 -13.5361 -20.5278 3.76808 -366 2 15.7097 7.21489 4.26906 -13.5998 -13.5183 6.32814 -367 1 17.3139 6.67347 0.0519528 8.75828 -11.5188 0.32751 -368 2 16.922 5.81479 0.236083 -1.36263 0.235584 3.31968 -369 2 16.5542 7.20912 18.4844 -8.7655 12.4237 -8.09845 -370 1 8.86065 6.91878 7.81669 10.1209 17.2302 -14.0365 -371 2 9.80786 7.17641 7.77744 -16.0922 -4.42618 4.57681 -372 2 8.74795 6.24147 8.48473 3.77983 -6.9476 8.96536 -373 1 12.3541 0.627989 1.20673 7.59332 -4.64776 2.86492 -374 2 13.2579 0.528374 1.53727 -3.51801 6.0046 2.76074 -375 2 12.2851 18.632 0.498856 -2.53947 0.382583 -4.14536 -376 1 5.64549 15.138 14.5235 -4.10456 -30.421 5.78959 -377 2 4.73353 15.1769 14.8501 2.72532 6.49481 -6.12593 -378 2 5.9656 16.0086 14.3294 1.76375 18.5631 -6.42604 -379 1 3.85619 6.49135 1.72458 1.34418 -5.76632 6.1851 -380 2 3.4082 7.28863 1.44351 -4.61345 8.91678 -8.73454 -381 2 4.04036 6.67595 2.65567 -1.04596 -4.79787 -3.17499 -382 1 3.88128 11.6181 12.3021 -8.90147 -4.54474 -0.675722 -383 2 4.76839 11.88 12.5585 3.1774 6.51538 0.922611 -384 2 3.25574 12.2257 12.7332 9.80963 -6.2977 -1.14662 -385 1 5.41097 3.86243 15.8619 7.77498 -26.7447 2.47729 -386 2 6.19051 3.2555 15.8125 -22.34 13.8462 -4.82428 -387 2 5.75732 4.74289 15.8731 9.06733 16.771 0.375084 -388 1 14.4275 10.3077 4.42737 -15.4583 -1.2468 24.8449 -389 2 14.4136 9.7945 5.25584 5.65105 6.60384 -6.24763 -390 2 14.7139 9.69599 3.76155 7.16087 -8.52398 -12.4829 -391 1 7.87022 17.3652 9.18307 -6.55512 0.129027 -0.760847 -392 2 7.04604 17.5698 9.62158 -5.94597 -4.85201 9.5143 -393 2 7.92762 18.0395 8.50377 8.60962 -1.46955 -8.60251 -394 1 4.50919 14.4633 3.94747 -3.26277 6.69504 -13.1744 -395 2 4.44326 15.3745 4.23469 1.61374 7.68172 -2.63862 -396 2 4.73121 13.9745 4.72809 3.38773 -13.7326 11.5154 -397 1 14.2916 7.39166 15.7799 -19.0102 -0.643935 -4.97281 -398 2 15.227 7.28492 15.6956 21.3172 -2.59108 -3.06 -399 2 14.1661 7.73476 16.6606 0.966931 5.43289 9.36717 -400 1 2.93597 18.2496 1.90178 2.72474 -19.4407 -7.90163 -401 2 2.41137 17.5137 1.50762 13.3283 19.165 4.04527 -402 2 2.31568 18.912 2.18531 -12.4791 7.28301 8.56329 -403 1 7.97625 1.60842 4.55987 -20.0747 11.2227 -5.58284 -404 2 7.40672 2.18903 4.02942 -3.00667 -10.939 3.58357 -405 2 8.83426 1.86357 4.26417 23.6954 -1.42515 0.234182 -406 1 2.55973 14.139 17.7235 4.4947 4.4122 -3.81652 -407 2 1.9869 13.4419 18.0532 -4.8721 0.171095 2.94118 -408 2 3.45785 13.8729 17.9629 -0.333069 -3.9381 0.822902 -409 1 0.778432 1.72633 13.8806 -27.0748 -1.51039 10.7449 -410 2 0.840363 1.33642 14.7677 3.59517 6.80992 -7.55552 -411 2 18.4512 1.86919 13.7675 25.1129 -0.50251 -4.23703 -412 1 4.5218 18.6217 13.9311 -26.2208 4.76485 6.31935 -413 2 5.44026 18.4597 14.0857 18.6112 -6.32709 -3.49173 -414 2 4.08533 18.4032 14.7706 3.39103 3.57256 -5.13956 -415 1 7.0966 0.590139 18.3583 40.0867 -7.03194 -16.485 -416 2 7.43029 0.218977 17.5038 -14.1267 7.45313 19.238 -417 2 6.15491 0.497007 18.3797 -17.6926 4.43938 -0.268226 -418 1 16.0869 18.4184 14.0665 12.1783 12.0602 19.9903 -419 2 15.2602 18.093 13.7757 -22.8702 -12.1677 -15.3509 -420 2 15.9307 18.6351 14.9998 9.22594 -1.26981 -3.76068 -421 1 10.0615 4.5254 16.2644 17.4965 34.4304 -0.599412 -422 2 10.952 4.96419 16.2693 -15.2122 -21.3498 0.578373 -423 2 10.2001 3.58581 16.3272 5.99955 -12.591 -1.94777 -424 1 15.8874 17.8488 4.44366 26.9944 -8.8935 -8.85545 -425 2 16.3583 18.6921 4.41154 0.375294 -2.3726 2.41747 -426 2 14.9936 18.0388 4.65191 -27.7242 10.9512 11.1951 -427 1 6.97313 17.3837 13.7492 -14.8371 0.980348 6.17816 -428 2 7.33935 17.5289 14.6184 6.46616 5.40365 9.01508 -429 2 7.73032 17.2786 13.1826 8.79779 -2.98362 -9.94394 -430 1 13.295 6.50203 6.69495 9.53809 17.2257 -14.0038 -431 2 14.0496 7.07319 6.46986 -0.499105 -8.31015 13.7378 -432 2 12.8724 6.42857 5.83749 -8.85952 -9.05901 -3.70628 -433 1 7.73318 2.36184 9.23357 -5.82839 -0.191385 25.6357 -434 2 7.13515 2.2598 10.0003 13.8878 3.27143 -3.38814 -435 2 7.19146 2.08044 8.50905 -8.01798 -3.82737 -18.8349 -436 1 15.1683 14.8678 13.6621 4.32457 -5.24538 6.92634 -437 2 15.0117 15.191 14.5524 1.96766 -1.10504 5.54809 -438 2 14.4461 15.1877 13.1369 -6.78809 4.58671 -11.3713 -439 1 9.33811 8.31525 3.72912 -3.71623 14.6513 -1.76526 -440 2 10.1422 8.72537 4.07444 1.32163 -4.04075 -0.39549 -441 2 9.3744 7.3721 3.88081 4.66337 -7.69389 3.46587 -442 1 17.73 13.5264 16.4473 3.62887 -10.5665 6.33517 -443 2 16.8053 13.2497 16.375 1.67263 6.91521 -3.1024 -444 2 17.8249 14.3621 15.9879 -5.28625 7.64018 -4.86126 -445 1 4.99014 10.6392 2.69296 -11.8842 10.0017 7.67541 -446 2 5.62836 10.2105 3.25699 12.1385 -6.17254 3.53336 -447 2 4.64978 11.3543 3.2597 0.304061 -9.29163 -9.90123 -448 1 3.7356 8.34279 10.2382 -0.81373 18.9096 -12.0232 -449 2 3.86658 9.26506 9.94102 0.197912 -10.4595 0.115104 -450 2 3.49052 8.44407 11.1547 0.601112 -5.92985 11.4704 -451 1 16.0428 7.05286 6.2029 -10.6575 13.2953 -5.82849 -452 2 16.855 7.48535 6.46978 4.82485 2.35526 4.73173 -453 2 16.1613 6.12013 6.32007 7.39497 -13.7867 -3.51418 -454 1 15.1327 7.05037 9.11575 3.87713 -5.32828 6.40762 -455 2 15.8626 7.43029 9.61535 2.26476 1.25298 1.00848 -456 2 15.1324 7.53151 8.29313 -1.46271 6.60183 -11.5025 -457 1 6.39444 13.0666 12.8402 5.00849 -18.9174 -4.31708 -458 2 7.14138 12.6166 13.2588 -1.3728 0.0732389 -8.28768 -459 2 6.25233 13.8543 13.3456 -7.70591 16.466 12.3405 -460 1 12.1285 4.48598 13.0882 -38.1563 -9.245 -8.92104 -461 2 12.05 4.67155 14.023 12.2106 4.08095 10.8898 -462 2 11.2367 4.10453 12.8753 29.4794 5.44987 -0.890783 -463 1 11.348 8.18475 7.8598 -17.4059 7.12531 -10.6431 -464 2 12.038 7.63484 7.48501 10.4081 -6.60064 5.31237 -465 2 11.4756 8.28116 8.80352 11.9689 -3.04214 7.26146 -466 1 17.1922 10.8074 7.44155 -25.4203 14.6985 18.6261 -467 2 17.9197 10.2075 7.32737 10.9985 -8.38668 -11.5183 -468 2 17.0629 11.3797 6.67504 9.09121 -1.65978 -2.87918 -469 1 5.25169 18.1248 11.0507 12.0648 3.50666 -3.83562 -470 2 4.62743 17.897 11.7414 -1.9785 0.423337 4.7613 -471 2 4.73712 18.33 10.2687 -7.94827 -3.02158 -5.48025 -472 1 7.57794 17.5568 1.83513 6.93874 5.3114 -35.8297 -473 2 7.86736 16.7596 1.34843 -3.99011 9.3379 11.9664 -474 2 7.57256 18.2518 1.1344 -7.92946 -12.1924 16.8763 -475 1 1.91036 12.9101 13.6013 -3.96045 -14.8375 -19.2024 -476 2 1.39392 12.2568 14.0828 0.939403 1.79227 7.54842 -477 2 2.06766 13.6568 14.1634 3.48639 14.3121 10.7878 -478 1 9.68075 6.78169 14.8149 2.18853 -17.0585 -1.56943 -479 2 9.86519 5.84438 15.0146 -5.66436 10.7434 4.7021 -480 2 10.1054 6.93436 13.9655 -4.91522 4.89205 -3.51643 -481 1 15.2489 4.31705 10.7696 10.3165 19.1063 17.7081 -482 2 16.2033 4.28261 10.8841 1.13215 -16.3849 -6.84609 -483 2 15.045 4.99149 11.4324 -10.9146 -3.35461 -8.40134 -484 1 11.2157 6.13912 0.184288 19.0347 18.6277 4.4365 -485 2 11.389 5.28379 -0.213728 -9.30505 -7.86745 -0.661886 -486 2 10.2971 6.41228 18.7766 -10.0409 -9.92482 -6.17869 -487 1 0.119384 11.3453 15.1007 -14.3711 11.1071 -8.9459 -488 2 18.1083 11.5338 14.3994 8.87914 -3.31428 2.86805 -489 2 18.675 12.1405 15.6491 -0.376992 -6.76779 4.41889 -490 1 7.06293 9.20482 7.26347 16.9728 2.93661 -2.33726 -491 2 6.45996 8.52415 7.5376 -12.746 -11.932 7.1182 -492 2 7.92776 8.76781 7.32981 -4.82181 7.51802 -3.03552 -493 1 18.3776 15.4097 12.3582 -11.3114 -7.16639 4.00893 -494 2 0.682756 15.4096 12.2525 13.0982 4.14044 -6.05458 -495 2 17.9899 15.7976 11.566 2.11158 0.973908 -1.02825 -496 1 16.5513 4.36706 5.24159 -5.09045 5.24791 -23.7034 -497 2 16.6166 4.33687 6.19466 14.1446 -5.59224 10.5876 -498 2 17.404 4.59908 4.81371 -8.86364 -4.80736 14.9956 -499 1 17.7417 3.09647 10.7341 0.291254 -10.6186 -10.4582 -500 2 0.00513181 3.34109 10.9087 8.18655 7.52385 6.55564 -501 2 17.8253 2.23203 10.2933 -8.67083 8.1401 4.47273 -502 1 12.2919 0.0227122 10.1361 2.29147 -28.3523 -7.04943 -503 2 11.4789 0.3695 10.4906 -11.5623 8.87459 2.77288 -504 2 12.9485 0.705533 10.1424 9.22066 20.6222 4.35768 -505 1 10.3653 9.79669 12.372 -8.95345 -3.20907 -9.5203 -506 2 11.0695 9.83133 13.0162 9.21286 -1.60231 7.36796 -507 2 10.2442 8.85709 12.1552 0.446892 6.98856 4.38647 -508 1 0.537603 2.83987 7.02256 -3.09155 -21.8169 -17.6677 -509 2 0.689112 3.48917 7.69969 6.81735 5.32415 12.4887 -510 2 0.745143 1.97019 7.39814 0.967775 11.9311 3.78775 -511 1 0.407687 15.2844 6.91114 -10.1505 12.0239 22.1786 -512 2 0.487576 14.9005 7.81264 0.770838 8.15944 -16.8401 -513 2 0.754028 14.6482 6.29753 4.41733 -17.9374 -4.37366 -514 1 17.0108 7.01877 15.2726 9.75856 -4.98107 -8.16179 -515 2 17.7945 7.53845 15.0774 -4.62906 13.8031 -0.900924 -516 2 17.4019 6.14594 15.3485 -8.43732 -9.20439 7.91006 -517 1 9.04118 12.4266 8.12126 20.8625 -13.8276 -21.4288 -518 2 9.31201 11.8186 7.41014 14.8696 5.22508 9.07579 -519 2 8.11227 12.3461 8.03152 -32.7632 10.2849 9.08461 -520 1 1.26557 1.8876 3.02782 9.65045 8.01813 1.36118 -521 2 0.751817 2.27104 2.32199 -7.08934 -1.28284 -8.05339 -522 2 1.78864 2.63408 3.35807 -1.4257 -10.3882 4.86199 -523 1 4.12138 15.1091 9.73113 11.5132 -2.98862 0.0844269 -524 2 4.08037 15.3711 8.80771 -6.64563 1.38763 -1.25331 -525 2 5.02377 14.7713 9.82789 -5.61093 0.302526 6.22582 -526 1 7.21558 2.18454 14.596 -3.30246 -13.7461 5.2135 -527 2 6.95017 1.78255 13.7582 4.82488 2.3919 4.06302 -528 2 7.77929 2.92256 14.3836 3.82883 9.51482 -6.38734 -529 1 18.5827 14.6796 2.1698 -24.3208 -2.36026 -2.50397 -530 2 0.827663 15.0286 2.10654 6.16868 9.29818 1.18622 -531 2 17.9285 15.4101 2.10387 15.0339 -9.50868 3.05979 -532 1 9.96457 2.76705 12.9307 -6.0306 9.60441 -0.715471 -533 2 9.81933 2.16697 12.1996 2.81266 -10.505 -5.71659 -534 2 9.23975 3.40361 12.8511 1.73763 -0.77134 6.44595 -535 1 2.86173 8.92609 13.0404 7.24036 -2.57601 -2.21085 -536 2 3.32754 9.76259 12.8684 -5.41233 -1.95407 1.34833 -537 2 3.53569 8.30272 13.3558 -0.616664 3.71534 -0.977901 -538 1 3.21505 8.40688 3.66968 15.7234 22.1036 -19.602 -539 2 3.76887 9.07341 3.20135 -16.7118 -11.852 2.14794 -540 2 3.39007 8.60458 4.57891 -0.363765 -1.98929 20.9454 -541 1 5.60252 7.19004 8.53175 5.86958 -4.86959 9.5617 -542 2 5.84506 6.27445 8.70563 -2.01066 -2.63063 -12.6146 -543 2 5.1548 7.42343 9.34691 -7.32508 9.6882 0.185442 -544 1 14.8904 1.34267 1.9851 -2.44355 -11.2972 17.4528 -545 2 14.6303 2.11535 2.51846 2.91157 0.487188 -15.3266 -546 2 15.025 1.53806 1.05778 2.17575 14.4946 -4.76666 -547 1 8.30348 15.1948 0.839181 1.62975 3.11742 -15.2912 -548 2 9.05101 15.1086 1.44328 -1.42893 -5.28711 5.64984 -549 2 7.54504 14.6965 1.17349 5.50357 -4.17517 7.24781 -550 1 15.6062 1.34647 7.22998 12.9139 6.24135 5.03718 -551 2 15.0343 0.764422 6.7383 -10.7397 -5.17 -5.22658 -552 2 15.1371 2.18077 7.35367 -5.42005 -2.19365 2.65732 -553 1 4.96367 13.0608 18.5175 -8.25637 -3.65043 -17.7207 -554 2 5.34878 13.2483 0.722802 8.16177 0.261597 12.4464 -555 2 5.65153 13.2431 17.8644 -2.22894 4.298 3.81358 -556 1 15.3614 8.50445 18.1376 -9.02232 -8.38547 12.9254 -557 2 15.7319 9.00583 17.4156 5.20151 10.9324 -8.24127 -558 2 15.1687 9.14311 0.198883 4.58141 -1.82544 -4.44514 -559 1 12.0904 3.05083 18.3558 5.74067 -18.2993 3.78166 -560 2 12.2947 2.48128 0.458355 -7.48955 9.04159 13.408 -561 2 12.4465 2.47277 17.6781 -3.43414 10.0689 -17.6065 -562 1 13.2065 12.6801 5.18634 5.84251 -1.21193 6.01102 -563 2 13.6832 11.8727 4.98831 0.374712 -2.89081 -11.6293 -564 2 13.5252 12.8732 6.07674 -9.12379 3.52213 -1.02632 -565 1 6.05538 7.10808 0.0622478 7.64822 4.54905 2.96407 -566 2 5.99209 8.01824 19.0386 -2.92171 -4.08442 -8.95141 -567 2 5.21644 6.68693 0.272307 -1.20959 2.69213 5.93171 -568 1 17.7218 15.9656 14.99 27.5308 -15.6865 18.0891 -569 2 16.9388 16.4863 15.1181 -14.3434 5.91292 -14.0866 -570 2 17.911 15.7342 14.0701 -14.8265 10.2647 -3.26624 -571 1 13.1712 0.994875 16.5867 2.52549 -1.56274 -3.32645 -572 2 14.0875 0.750433 16.7652 2.07951 0.899412 2.60052 -573 2 12.7522 0.177983 16.2988 -0.931869 -3.47373 4.92885 -574 1 11.0723 14.6005 7.26575 -13.1255 -10.0571 4.65979 -575 2 10.3507 14.0428 7.62559 10.576 8.81418 -2.61622 -576 2 11.902 14.168 7.50495 -4.44994 -4.81764 -1.49609 -577 1 17.5239 8.59779 2.09084 -4.28833 -20.5194 -15.9758 -578 2 16.6824 8.33187 2.48237 1.37862 7.81735 4.46419 -579 2 17.5834 7.99355 1.32242 5.93631 9.11716 13.4418 -580 1 12.3581 7.93946 1.97566 -1.89696 -6.27914 -3.50436 -581 2 11.9505 8.79823 2.04436 -0.86405 10.6038 1.69948 -582 2 11.9097 7.53044 1.22383 5.98844 -6.29912 5.7943 -583 1 11.9176 14.6241 10.3724 -2.87076 17.8373 18.3305 -584 2 12.1889 13.9308 9.80998 14.0474 -22.5763 -16.4958 -585 2 11.017 14.792 10.1004 -10.4734 4.60408 5.02203 -586 1 6.86179 7.0045 15.5825 0.298402 -7.5032 -11.9192 -587 2 7.72978 7.09161 15.1865 4.58892 -5.83629 -5.839 -588 2 6.8806 7.68521 16.2363 -7.39186 11.3873 16.6815 -589 1 8.0061 4.66768 13.4643 -26.1906 -20.4665 -29.1007 -590 2 7.40104 4.82554 12.6933 13.2028 -5.13213 23.0799 -591 2 8.47723 5.469 13.5831 13.4856 24.6751 2.60837 -592 1 13.392 12.1682 14.29 6.21681 3.24263 -1.56593 -593 2 13.3744 11.2127 14.1772 -7.69192 -2.80185 3.02585 -594 2 13.9051 12.489 13.5384 -1.40129 2.2659 -1.62493 -595 1 14.7806 9.45441 7.28093 -11.5532 20.7697 15.955 -596 2 15.4984 10.0862 7.4818 -3.61589 -14.7511 -6.73617 -597 2 14.0294 9.75726 7.82532 9.94729 -6.45384 -10.5104 -598 1 12.6903 16.9959 3.11063 13.9021 -20.0527 -1.11079 -599 2 13.0479 17.2495 3.95961 -1.86196 6.25123 9.18833 -600 2 12.0243 17.6278 2.88206 -13.6174 14.7021 -2.85583 -601 1 1.14933 7.13689 17.4392 -10.8552 -5.82346 1.42608 -602 2 0.254324 6.85235 17.6903 1.68989 10.0465 1.1249 -603 2 1.04814 7.64429 16.6282 0.816381 -0.80389 -4.56811 -604 1 12.8311 5.11146 15.6849 -17.6595 -4.33947 -1.38663 -605 2 13.5036 4.46543 15.459 7.94947 -3.95791 3.77703 -606 2 13.2565 5.97185 15.6774 7.16 2.75079 -1.64654 -607 1 2.47852 3.39671 5.05511 -15.8601 -20.9034 -7.20071 -608 2 1.89248 3.0773 5.76599 4.829 7.89548 -3.4806 -609 2 3.06433 4.04634 5.42706 4.34046 14.9349 7.02505 -610 1 8.31182 11.2281 13.4853 12.2486 -8.92827 -7.03776 -611 2 8.34382 10.988 14.3869 -16.2376 0.866389 37.005 -612 2 9.12412 10.7865 13.2309 -0.249665 2.67206 -26.3927 -613 1 12.9087 1.417 13.3166 0.0274524 -25.355 19.3096 -614 2 13.4801 1.21198 12.5759 3.32243 8.60198 -10.444 -615 2 12.4274 2.20637 13.1188 -4.80778 18.3372 -7.59901 -616 1 6.3961 13.6531 2.14242 21.3539 -7.72513 -19.5528 -617 2 5.86296 14.1246 2.76583 -10.9825 4.85946 19.6126 -618 2 7.0399 13.1177 2.63436 -6.77103 3.35988 1.82582 -619 1 15.9312 6.57282 12.7577 9.39393 9.94387 -6.4398 -620 2 16.4454 7.11896 12.1297 -10.141 -7.43973 7.84454 -621 2 16.2972 6.7745 13.6327 -0.398164 -4.05689 -3.4507 -622 1 16.8338 0.714138 9.59622 -4.58014 7.56344 -3.36861 -623 2 16.786 18.4184 9.78234 2.45796 -8.84878 0.088887 -624 2 16.3762 0.83732 8.75167 2.21028 0.792186 -0.559114 -625 1 6.14371 11.7069 8.36929 2.81279 3.26044 -4.5559 -626 2 5.21452 11.6136 8.62066 2.93526 -5.28935 1.80511 -627 2 6.46143 10.8412 8.07651 -3.38714 0.356066 2.25694 -628 1 2.85881 8.67012 0.388915 2.79689 11.0982 14.7719 -629 2 2.20875 8.30366 18.4701 -9.93413 -28.5632 -26.9968 -630 2 2.30006 9.32334 0.801848 8.26615 13.7996 15.8107 -631 1 10.1321 10.4555 6.53489 -7.45039 0.329373 10.0784 -632 2 10.6046 9.83719 7.10845 -0.190248 -0.487921 -4.0191 -633 2 10.6634 10.5725 5.74842 5.176 -1.34798 -7.09506 -634 1 6.75471 15.7115 6.57125 -11.9312 -6.35937 -2.57899 -635 2 7.17812 16.0056 7.37746 4.55156 8.98271 2.0062 -636 2 6.84858 16.4009 5.89838 10.4548 -3.40393 4.92981 -637 1 6.44667 13.1112 5.62964 2.65073 6.32881 3.74437 -638 2 6.67596 13.9769 6.00675 -0.0120675 -6.80172 -3.34498 -639 2 5.96115 12.6448 6.31389 0.45756 -2.92263 2.45964 -640 1 16.7937 12.5442 9.80018 5.98989 11.7335 -8.95445 -641 2 16.9887 11.9765 9.05284 -0.702856 -11.4944 -2.64553 -642 2 17.0098 13.4184 9.45025 -4.64512 -2.35242 9.41775 -643 1 6.08081 2.94855 2.81201 5.81343 6.87552 13.2918 -644 2 6.21399 3.88965 2.59312 -1.02666 -12.0092 -4.68113 -645 2 5.77459 2.45978 2.03916 -1.91968 5.61369 -5.09877 -646 1 10.8797 3.26448 3.27711 -5.41025 -2.45564 -6.20574 -647 2 10.301 3.99846 3.49319 -0.0844139 2.78359 4.78679 -648 2 10.5123 2.93026 2.45079 3.61554 -5.12824 0.569032 -ITEM: TIMESTEP -40 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.73557 7.01799 17.9607 21.964 -6.69295 -3.41675 -2 2 7.837 6.97936 18.244 -22.923 1.28376 8.03757 -3 2 8.84363 6.25859 17.3828 1.27689 0.0651665 -4.69765 -4 1 18.6647 8.30209 6.83035 -0.644058 3.99523 -48.5507 -5 2 0.211245 8.12789 5.86514 -9.60619 8.91963 25.083 -6 2 0.465598 7.58914 7.26037 9.90688 -14.2806 22.1152 -7 1 8.44495 18.6364 6.8238 -19.0399 -0.344231 6.51496 -8 2 9.34052 0.200584 6.61788 21.6732 5.78047 -4.99449 -9 2 7.92466 0.711623 6.44684 1.16681 0.183702 -1.11302 -10 1 6.56005 1.80411 11.6838 -38.7214 4.43655 14.793 -11 2 5.75321 2.272 12.0538 30.5925 -16.6996 -9.96133 -12 2 6.22943 0.898268 11.5156 6.32845 11.0599 0.0206858 -13 1 7.08366 5.68816 2.38617 22.7225 -30.9477 -12.475 -14 2 6.58152 6.21056 2.95839 -27.8787 23.1579 37.4024 -15 2 6.84697 6.04683 1.54845 0.038941 9.08719 -25.9535 -16 1 16.22 10.2137 16.0864 41.4588 -5.13522 6.23048 -17 2 17.1921 10.3703 16.208 -28.8473 -8.8876 -9.54756 -18 2 15.8271 11.0171 16.4051 -13.971 12.6367 2.51598 -19 1 10.6448 14.9575 2.33364 6.27542 19.2207 -0.856148 -20 2 10.5562 14.6084 3.22703 2.40752 -4.54155 -3.02292 -21 2 11.1101 15.8129 2.46012 -8.85901 -18.4002 -3.84051 -22 1 17.1611 8.2532 10.553 -11.2529 -0.0170881 12.6501 -23 2 16.8393 8.94572 11.1538 -1.12797 -5.57792 -5.31501 -24 2 17.9446 8.61302 10.1436 10.8511 4.56282 -2.94704 -25 1 14.7728 15.897 16.3892 -19.7826 14.9663 0.46496 -26 2 13.8411 16.2137 16.4626 21.4068 -5.53606 -7.5515 -27 2 14.9622 15.5552 17.2653 -0.403084 -10.0705 4.87845 -28 1 12.136 13.4022 0.475357 -11.3959 -2.02194 -12.751 -29 2 11.9408 13.3873 18.1673 8.9331 -2.53085 4.8524 -30 2 11.4037 13.9022 0.849725 6.62825 2.84238 11.8203 -31 1 9.29338 5.44787 4.01163 24.6694 12.616 -29.9837 -32 2 8.80858 5.1972 4.76287 -21.098 -14.9153 34.0625 -33 2 8.63435 5.49966 3.31701 -4.42724 -1.21089 -8.36553 -34 1 1.79376 4.18976 11.6282 4.46954 -46.7602 7.51249 -35 2 1.70048 5.09501 11.8512 -4.37305 32.1952 10.6933 -36 2 2.09275 3.70286 12.4334 -4.9207 12.4729 -20.4441 -37 1 2.01732 6.80615 8.34226 1.64844 10.8358 -0.647304 -38 2 2.37448 7.3471 9.0762 -2.77819 -13.6149 -8.9692 -39 2 1.92609 5.89421 8.65385 1.80745 6.26657 1.98394 -40 1 5.38901 4.42498 7.95307 14.0474 9.0477 19.097 -41 2 5.49608 3.48465 7.79451 -4.39314 -7.26091 -3.25333 -42 2 4.79389 4.80722 7.31869 -10.598 0.276841 -18.5158 -43 1 3.29732 2.94293 17.5086 17.2208 -30.0882 -17.6092 -44 2 4.02601 3.30007 16.978 -4.8938 2.423 1.99348 -45 2 2.81217 3.66256 17.8655 -12.7512 26.7583 13.4218 -46 1 7.44366 5.31542 6.10005 -2.04578 -15.3999 -38.6663 -47 2 8.07874 5.97061 6.33436 13.5587 20.8049 21.0336 -48 2 6.95124 5.08125 6.86821 -11.582 -6.53412 22.3247 -49 1 9.78574 7.01841 12.0035 -14.224 -5.31732 -23.9819 -50 2 10.3573 6.41663 11.5027 -2.93892 5.75769 9.08141 -51 2 9.02058 7.16943 11.392 19.9248 1.87014 17.2782 -52 1 14.0222 3.60384 8.07347 21.1656 -3.6634 36.3987 -53 2 13.9951 4.24089 7.37961 -2.65045 17.7741 -13.562 -54 2 14.5465 4.02482 8.8088 -19.0215 -13.1146 -21.9867 -55 1 4.60432 17.1743 3.97092 -4.17058 -8.50894 9.4345 -56 2 5.51528 17.3741 4.10719 24.7317 1.00316 8.45766 -57 2 4.31895 17.8257 3.35422 -16.1123 9.67587 -20.1592 -58 1 16.4938 16.6102 10.1803 -22.58 10.2442 28.8776 -59 2 15.6971 16.8258 10.7464 27.0105 -10.9286 -19.8859 -60 2 16.1827 15.9878 9.51957 -5.57273 -0.00226425 -4.98818 -61 1 1.9645 4.84741 0.368078 -14.0488 -12.8308 -13.2388 -62 2 2.69854 5.15593 0.879033 14.2396 9.43314 15.7095 -63 2 1.5724 5.64147 0.000503254 -0.0595591 4.00938 -5.12573 -64 1 11.6747 13.3071 16.3147 -7.05005 22.2307 18.0491 -65 2 11.0866 12.5598 16.3919 -3.1788 -17.5748 -3.92498 -66 2 12.2584 13.1709 15.5748 2.75178 -8.36686 -13.1919 -67 1 10.131 11.038 16.8986 -21.0542 26.9507 -1.58256 -68 2 10.4848 10.1706 16.8573 15.2828 -28.4038 0.505132 -69 2 9.17797 10.924 16.7712 4.48065 0.743861 -0.190366 -70 1 11.7352 17.4666 13.4614 -1.07936 25.6776 8.56908 -71 2 12.4835 17.2209 12.9203 3.02318 -9.35187 -8.63799 -72 2 11.8077 18.4454 13.5145 -0.798306 -16.7366 -1.43427 -73 1 6.39395 9.3313 12.2301 16.0138 21.1557 17.835 -74 2 6.78657 8.92292 11.474 4.59605 -10.3711 -18.9433 -75 2 7.12055 9.89522 12.5742 -21.4515 -7.31443 1.84288 -76 1 16.2436 12.8045 2.69297 9.19112 6.28957 -1.09055 -77 2 17.1119 13.1995 2.45018 -21.0084 -1.00278 4.98407 -78 2 15.5746 13.5129 2.79044 13.212 -4.74068 -2.98151 -79 1 0.66547 12.6008 5.89246 44.3801 0.278469 12.8923 -80 2 0.944588 12.4662 4.9918 4.15776 -1.70344 -11.3497 -81 2 18.3844 12.6561 5.85431 -44.3715 7.63264 -5.03051 -82 1 5.23201 16.4301 18.4413 -23.1671 11.3407 -2.74477 -83 2 5.81563 15.7669 18.0873 14.8521 -9.88299 1.40517 -84 2 5.51268 16.7513 0.656182 8.57816 -5.72834 2.04059 -85 1 0.568352 7.66823 4.13077 -28.9792 -20.0076 22.3714 -86 2 18.6051 8.03762 3.49503 -7.9612 4.34402 -11.87 -87 2 1.4037 8.01472 3.91532 39.463 15.435 -13.2826 -88 1 3.11888 8.95318 6.49662 60.4725 2.42495 -6.82714 -89 2 3.7308 8.46704 7.08062 -7.96075 9.2896 -8.18079 -90 2 2.27986 8.68504 6.76207 -50.4171 -10.8396 15.4956 -91 1 7.30368 10.3509 16.2473 20.2996 0.0228567 -17.1566 -92 2 6.66358 10.504 15.5564 -7.99994 0.888183 -0.524161 -93 2 6.82737 10.217 17.0566 -12.2765 1.21271 14.6854 -94 1 11.12 1.01485 5.00375 -0.0102216 2.84952 14.1843 -95 2 11.0857 1.87302 4.56078 2.3673 -3.0702 -4.20032 -96 2 10.7324 0.367128 4.41621 -3.73217 -2.39612 -13.1961 -97 1 4.37027 2.7904 13.2033 3.18584 17.5115 -8.99997 -98 2 4.79356 3.08499 14.0007 6.25053 15.0735 9.59097 -99 2 4.18046 1.89747 13.4272 -8.57413 -32.1756 -2.785 -100 1 8.40183 10.1302 1.81819 -11.3119 21.1596 -20.1509 -101 2 8.22596 10.8234 2.46526 3.55036 0.443395 1.34914 -102 2 8.74004 9.40086 2.30376 11.7587 -22.7948 15.5041 -103 1 10.4641 1.71908 15.5611 14.2583 -4.22402 3.33599 -104 2 11.4066 1.52258 15.371 -17.8532 5.60176 1.9802 -105 2 10.08 2.13518 14.7824 5.57904 -1.0897 -7.54918 -106 1 2.70316 12.9014 7.80195 3.19617 10.9991 1.8073 -107 2 3.3212 13.5754 7.49282 0.460726 -0.40643 1.73206 -108 2 2.13336 12.7538 7.04495 -5.07282 -6.75217 -1.11681 -109 1 3.70861 11.6625 5.14703 20.6482 18.5599 0.117703 -110 2 3.55555 10.8287 5.56068 -6.18613 -18.2271 10.4705 -111 2 3.04771 11.7826 4.47739 -15.5561 1.61657 -8.41129 -112 1 6.75631 14.4548 16.9127 8.94674 -1.78931 -0.924301 -113 2 7.71443 14.3361 16.9267 -6.94418 4.38523 0.882829 -114 2 6.52635 14.6721 16.0018 -2.96874 0.297136 0.835917 -115 1 14.1768 14.5549 3.37546 -9.20747 -5.25648 5.53536 -116 2 13.5738 15.2994 3.18581 6.88801 -12.7747 3.05988 -117 2 13.7349 13.9262 3.9882 4.46288 16.3838 -11.0193 -118 1 8.36945 18.1316 16.043 -50.6417 14.5597 -0.377943 -119 2 8.83326 17.39 16.374 32.1095 -21.5179 4.54953 -120 2 8.87194 0.178112 15.6264 24.4627 6.71878 1.23367 -121 1 4.74402 1.66109 4.92978 -19.7446 -31.5867 36.4561 -122 2 3.83516 1.95374 4.92736 -8.28526 7.01041 1.88485 -123 2 5.14187 2.10852 4.23181 25.7722 28.9669 -41.4039 -124 1 15.0327 12.6922 16.4463 -14.1895 -13.4373 -36.9651 -125 2 14.5853 13.1594 17.1179 -4.44761 17.5587 33.5367 -126 2 14.3173 12.6168 15.7704 28.0544 -5.79477 6.54775 -127 1 15.7455 18.4472 16.8494 -36.7721 -17.2537 -45.0168 -128 2 16.3082 18.5742 17.5575 42.6678 12.9246 46.9817 -129 2 15.6033 17.4929 16.845 -6.46687 1.33922 -4.84851 -130 1 1.19925 1.17644 16.5482 3.81725 -14.252 -17.647 -131 2 1.9494 1.76296 16.5282 11.9166 8.08174 5.38627 -132 2 0.720072 1.41993 17.3243 -10.8728 8.87917 17.8692 -133 1 18.1194 4.51517 15.8978 -9.12682 11.3324 16.5545 -134 2 18.3907 3.99589 15.1624 6.35448 -14.0345 -18.3092 -135 2 0.212938 4.54105 16.5062 3.72114 1.23331 1.72655 -136 1 12.2575 16.9791 16.1441 20.307 19.4582 -44.4732 -137 2 11.5756 16.5974 16.6415 -35.2707 -20.5418 23.5889 -138 2 11.9443 16.955 15.2053 9.79722 2.45701 21.3583 -139 1 15.9948 2.53341 18.0767 10.9381 -15.7258 5.9061 -140 2 15.4972 3.23449 18.4655 -6.78731 22.0319 12.1926 -141 2 15.8185 2.63494 17.1497 -1.81081 -2.22204 -19.1287 -142 1 6.71322 13.8205 10.2184 4.21251 -0.72826 -19.8354 -143 2 6.51318 13.5527 11.1172 -1.15071 -8.01371 4.0626 -144 2 6.63912 13.0526 9.6212 -3.83744 4.98216 12.3358 -145 1 10.1462 18.2988 2.74675 -22.097 -20.0437 20.6404 -146 2 10.3757 0.350258 2.15404 6.85623 19.4082 -18.4799 -147 2 9.18692 18.1396 2.61143 20.6475 -0.265938 -2.33946 -148 1 3.01179 17.7216 6.11391 16.3646 11.1083 -7.5066 -149 2 2.20644 17.7129 5.60578 -13.7656 -5.82691 -3.27397 -150 2 3.67703 17.9821 5.44947 -4.29715 -10.1951 11.4126 -151 1 12.5763 16.9057 8.00279 34.6812 6.34788 -19.799 -152 2 11.842 16.3339 7.82778 -18.535 -10.6459 7.52248 -153 2 12.4277 17.4882 8.74445 -13.6741 4.98834 7.73701 -154 1 14.8867 15.2801 8.21669 15.2681 -20.6133 -0.236719 -155 2 14.2473 15.9935 8.15265 -4.83203 2.49296 -8.82369 -156 2 15.4177 15.201 7.39136 -14.8487 16.0275 12.7595 -157 1 17.673 18.2386 0.358056 6.39969 9.72416 1.64776 -158 2 18.5627 17.8182 0.243387 -17.6184 17.4743 1.20562 -159 2 17.7074 0.56338 0.562155 11.394 -25.7036 -4.78753 -160 1 0.840605 10.4115 1.35744 37.4959 50.4012 -24.017 -161 2 0.0672579 9.99096 1.64345 -42.7842 -22.4511 10.6341 -162 2 0.58692 11.2092 0.808654 3.76922 -28.1369 19.051 -163 1 1.6843 12.2358 3.38047 -6.18426 -19.2714 -7.57792 -164 2 1.35621 11.4726 2.83119 9.65923 28.3457 4.48748 -165 2 1.68469 13.0653 2.87986 -2.69674 -10.3555 -4.68476 -166 1 0.583101 17.235 4.89274 4.80321 -10.1773 15.6529 -167 2 18.7212 18.0548 4.74777 -0.344371 -10.7938 17.6071 -168 2 0.457865 16.8228 5.79389 -3.26711 20.5272 -26.9728 -169 1 1.10197 0.931397 9.43269 -15.4399 -19.3078 -9.02275 -170 2 1.25908 0.443364 10.2575 0.781623 10.2528 -2.87546 -171 2 0.281175 0.525265 9.08113 16.3171 12.9297 7.39947 -172 1 16.7532 2.33623 13.2905 -6.48112 -9.83965 38.5991 -173 2 16.8955 2.59135 12.4052 6.16672 6.51778 -37.0535 -174 2 16.4416 1.41783 13.3009 4.47832 4.66932 -0.969858 -175 1 2.60624 15.8504 12.1681 -27.4943 19.2901 -21.9402 -176 2 3.16839 15.391 12.7532 19.3125 -15.6847 20.968 -177 2 2.92961 15.6774 11.278 4.5792 -4.36857 -3.32021 -178 1 16.4212 15.6424 6.03078 2.33398 -27.7044 12.4884 -179 2 17.3276 15.7008 6.32 9.77501 -6.8374 8.24343 -180 2 16.3266 16.4053 5.49767 -10.7497 25.3256 -21.0495 -181 1 5.80196 5.07502 11.792 -7.0375 5.38003 9.08436 -182 2 5.27256 5.62589 12.4097 12.9595 -6.51078 -10.685 -183 2 5.4277 4.18781 11.8485 -2.70068 5.27459 0.5345 -184 1 15.1729 4.86274 0.750774 -1.10571 10.9128 -33.6343 -185 2 15.2042 4.59535 1.64712 -4.27265 -9.78555 34.3171 -186 2 14.3466 5.34824 0.643665 4.19718 -3.49047 -1.12139 -187 1 16.3347 16.3636 2.07743 2.17372 -8.94604 27.567 -188 2 16.248 16.684 3.01162 -4.2135 -4.93901 -27.3972 -189 2 16.5997 17.1143 1.55727 4.53602 12.7734 -5.95158 -190 1 0.261441 4.84804 3.8055 -0.147017 -56.3045 13.8461 -191 2 0.475233 5.74211 3.84367 9.07909 56.4423 -0.745388 -192 2 0.927869 4.41838 4.37361 -9.48651 2.83213 -9.85838 -193 1 2.95802 15.0603 15.1014 -0.943114 0.172839 -27.3629 -194 2 2.80338 14.7297 15.9709 -3.98201 -9.31011 23.138 -195 2 2.36314 15.8122 15.0164 6.10514 4.60789 3.27938 -196 1 1.13815 14.652 9.54287 -29.9359 -26.3887 42.7894 -197 2 1.85794 14.2975 9.07203 33.137 -5.88851 -26.0645 -198 2 1.02375 13.9289 10.2175 -6.6715 26.0405 -18.8729 -199 1 13.5762 16.6063 11.5459 8.2131 -23.6119 0.793767 -200 2 13.33 17.296 10.9485 -9.11427 22.0857 -7.2987 -201 2 13.1805 15.8285 11.1175 -0.169415 1.89227 9.19008 -202 1 4.67714 1.46335 0.758621 16.4224 4.90719 -8.19047 -203 2 4.16601 2.0159 0.158762 -4.20381 1.9839 -0.0593356 -204 2 4.09672 0.7797 1.07984 -10.7002 -7.55851 6.47825 -205 1 1.4518 18.552 11.8572 6.2605 -28.7314 5.6203 -206 2 1.30143 0.363179 12.6934 -0.382356 1.32639 0.00372943 -207 2 1.68394 17.6168 12.0771 -1.80479 24.861 -1.36748 -208 1 11.5075 10.1198 4.02095 -18.4811 -8.70186 23.5865 -209 2 11.1917 10.5684 3.24759 -2.79925 6.67004 -19.1711 -210 2 12.4478 10.2129 4.02159 23.6747 0.339266 0.782627 -211 1 8.31226 12.1774 3.6909 13.3967 -8.0925 -50.6166 -212 2 9.08853 12.6634 3.95409 8.19758 6.83683 10.985 -213 2 7.73108 12.1161 4.40989 -25.5486 3.81511 42.2514 -214 1 14.4234 4.01167 3.27932 -6.39999 -0.808874 -15.5703 -215 2 15.0318 4.04602 4.01015 9.81333 2.6424 13.2185 -216 2 13.6949 4.61166 3.47516 -0.628596 -1.04819 4.76047 -217 1 5.60276 1.68001 7.51543 46.6974 51.3536 -38.165 -218 2 4.99884 1.09753 7.87161 -47.5789 -43.021 28.4342 -219 2 5.32972 1.80197 6.58421 6.01087 -7.11276 10.7862 -220 1 17.8847 1.08156 4.86879 -16.2479 -18.084 1.95698 -221 2 18.6198 1.37964 4.35055 14.6356 14.0949 -7.48199 -222 2 17.763 1.66674 5.61639 2.20316 6.60999 2.39214 -223 1 6.81142 9.41573 4.49306 -0.655622 0.432156 7.98772 -224 2 6.876 9.60924 5.45033 2.30801 -5.82211 -14.8304 -225 2 7.69814 9.2085 4.16641 0.21776 -0.211816 8.23149 -226 1 2.64622 14.9044 1.97705 -19.6169 -6.34757 32.4999 -227 2 3.24366 14.6749 2.7111 -2.05224 3.38495 -12.0409 -228 2 3.14951 14.9574 1.1885 18.3224 0.185563 -21.7099 -229 1 17.3026 12.9105 13.1506 5.97988 10.8617 -4.35729 -230 2 16.4943 13.3715 13.3508 -17.5214 -4.76439 4.13034 -231 2 17.8495 13.6655 12.9025 6.83053 -7.65676 -2.15198 -232 1 14.953 10.5544 1.38215 35.2581 29.1908 17.9973 -233 2 15.5812 11.2612 1.74238 -25.4064 -29.0048 -15.0024 -234 2 14.0938 10.9575 1.42777 -9.92862 1.12257 -1.65093 -235 1 5.7132 6.77849 4.57909 1.57168 19.8101 -12.7812 -236 2 6.1646 7.64962 4.62346 -11.1008 -12.4177 -0.29751 -237 2 6.30742 6.13992 4.97063 6.93571 -3.41618 11.3539 -238 1 8.02607 8.31482 10.3199 -6.67367 -6.11991 -5.1902 -239 2 8.5826 9.1064 10.2496 0.567217 -7.04018 -13.4516 -240 2 7.81744 7.96553 9.42928 8.80325 8.4252 13.4279 -241 1 13.463 18.3942 5.75922 18.2094 9.72717 -25.7917 -242 2 12.7029 0.253225 5.44631 -3.25776 3.56949 4.30859 -243 2 13.1448 17.7819 6.40042 -11.4028 -12.4364 22.7676 -244 1 0.157572 2.62906 0.18715 -8.27583 -44.4001 -2.30616 -245 2 17.9404 2.90438 -0.139246 -4.84787 10.7772 1.25282 -246 2 0.728557 3.33866 0.428035 8.4047 29.5908 2.16632 -247 1 12.7834 11.0467 9.74512 50.2143 -37.9981 33.2215 -248 2 11.9361 11.0491 9.39224 -54.8114 3.18277 -19.015 -249 2 12.8684 10.1188 10.1004 3.84712 25.3375 -10.5627 -250 1 0.745434 12.1889 11.0782 -25.5268 2.00553 -1.18025 -251 2 18.4134 12.2219 11.1204 10.6569 -0.780029 -7.62666 -252 2 1.00048 12.4147 11.9671 12.4315 1.99225 10.3147 -253 1 5.08453 7.29937 13.4403 2.24753 -3.99956 1.86213 -254 2 5.64891 7.85147 12.8757 -3.98378 2.58677 10.115 -255 2 5.52437 7.26557 14.3066 0.821915 -2.02828 -9.69703 -256 1 1.22699 6.88005 11.8698 42.6355 29.3241 27.8417 -257 2 0.513102 7.24659 11.3736 -15.3023 8.70694 -9.89945 -258 2 1.76616 7.68013 12.1994 -27.3906 -36.7234 -16.475 -259 1 15.5048 9.56381 12.3059 14.0365 -21.5239 -8.17825 -260 2 15.0446 10.3738 12.2505 -11.2614 35.3449 -7.27588 -261 2 15.2981 9.243 13.1696 0.51668 -8.53923 17.0206 -262 1 16.6213 12.8097 5.50479 11.7533 -20.9364 35.7876 -263 2 16.4281 13.7341 5.58129 -4.58024 20.9264 -6.48074 -264 2 16.496 12.5383 4.61195 -7.15835 1.38375 -28.6034 -265 1 6.25272 9.92074 0.051253 25.5558 -5.2213 19.2814 -266 2 5.65499 10.4134 0.617489 -6.63873 2.74854 -0.55683 -267 2 7.09279 9.88715 0.575545 -19.794 1.5448 -11.6918 -268 1 12.3217 6.11544 4.06855 24.0308 27.0278 -26.8963 -269 2 12.2667 6.69224 3.25542 -0.750296 -12.6773 27.7542 -270 2 11.603 5.51542 4.01585 -23.4349 -14.6267 -3.11795 -271 1 0.228308 12.8043 0.188232 11.1572 0.898125 2.61316 -272 2 0.191448 13.5221 0.829575 -7.01271 0.62324 2.49922 -273 2 18.423 13.1312 18.0517 -4.48315 2.42872 -7.20237 -274 1 3.7281 18.597 8.57641 -7.3642 13.4464 17.6561 -275 2 3.55952 18.0214 7.8301 -5.82536 1.28732 -6.71467 -276 2 2.87154 0.379366 8.79158 11.2944 -8.20129 -4.53508 -277 1 7.45075 17.3023 4.47746 -12.4687 -31.8552 -5.62811 -278 2 7.62794 18.1881 4.68695 9.53175 40.2972 16.7849 -279 2 7.50734 17.3052 3.52795 -1.99738 -6.99443 -12.8094 -280 1 9.24058 17.0897 12.2501 -24.9009 9.53262 -6.54721 -281 2 9.25026 16.4035 11.594 -4.50925 -12.7792 -11.7902 -282 2 10.1098 17.0766 12.5981 28.7243 3.47903 16.8433 -283 1 13.2876 12.9366 7.99409 13.1339 47.0026 -12.7195 -284 2 13.3658 12.2269 8.61754 6.78146 -9.97429 11.7811 -285 2 13.946 13.6564 8.215 -16.5737 -23.9385 -2.8436 -286 1 14.9278 2.97205 15.3542 -22.0243 3.95222 27.314 -287 2 14.2978 2.24466 15.255 3.92553 0.418625 -2.59085 -288 2 15.495 2.9795 14.6023 14.212 -3.72656 -21.152 -289 1 9.88733 15.5502 16.9939 -6.96656 2.06857 9.21519 -290 2 10.3024 14.7219 16.7214 3.24805 0.519307 1.1538 -291 2 9.47388 15.4159 17.8681 4.17307 -0.448199 -10.2742 -292 1 11.3272 8.33778 16.5655 -12.1447 -4.13113 3.07889 -293 2 10.5941 7.97459 16.029 11.4521 -0.447246 11.036 -294 2 11.3675 7.80686 17.3849 -1.98947 6.30133 -12.9317 -295 1 3.91087 18.2078 16.7523 8.10648 -24.8729 2.7978 -296 2 4.29329 17.4751 17.2712 -2.30537 5.45923 -13.1249 -297 2 3.83261 0.235403 17.405 -4.96911 23.3333 9.68201 -298 1 2.20524 4.16671 8.93127 -30.922 4.24465 -33.9389 -299 2 3.10409 4.18899 8.66341 29.7515 -2.18627 -0.590115 -300 2 2.16419 4.10976 9.8632 4.73941 -5.36165 36.7803 -301 1 9.8752 10.3748 9.71669 16.1383 -34.8575 15.3318 -302 2 9.43878 11.1114 9.34267 -12.9257 32.2344 -10.6144 -303 2 10.0704 10.5459 10.6459 0.567735 2.49547 1.17829 -304 1 9.70603 0.859612 10.8594 11.2219 3.05072 8.41213 -305 2 9.26848 0.0594607 11.2011 -2.07101 7.3453 -10.3505 -306 2 9.18365 1.30902 10.1791 -6.8322 -10.1071 2.86508 -307 1 9.20299 15.1273 10.2305 31.122 11.5717 5.63223 -308 2 8.76871 15.6899 9.60445 -9.85228 15.7354 -8.32779 -309 2 8.63472 14.3875 10.3233 -23.0991 -20.0884 3.25194 -310 1 0.96837 9.47951 10.2963 -70.5876 8.50765 14.6853 -311 2 0.835229 10.4182 10.5095 11.9906 -6.34251 -2.52384 -312 2 1.84768 9.33537 10.0919 56.817 -0.102153 -14.2985 -313 1 16.9556 4.85371 8.1764 15.2186 15.5475 -39.5257 -314 2 16.4324 5.61135 8.41217 -10.5813 9.18021 7.17639 -315 2 16.8473 4.22258 8.84986 -2.43363 -23.5078 29.961 -316 1 14.6968 14.7113 0.249291 21.1749 6.84176 -19.9636 -317 2 15.2416 15.0749 0.948116 1.7369 4.80193 6.96981 -318 2 13.9408 14.343 0.670519 -22.6431 -9.26918 11.3127 -319 1 3.62773 11.0513 9.55661 13.6415 -11.4582 11.5887 -320 2 3.64622 11.3868 10.4653 -1.2087 2.23818 -2.33891 -321 2 3.18854 11.7052 9.01978 -9.00441 8.94912 -6.83793 -322 1 11.1486 10.7845 1.39435 -11.9859 -27.9615 14.113 -323 2 11.4982 11.6036 1.1014 8.88176 28.2378 -14.4203 -324 2 10.2242 10.7355 1.11217 4.88573 2.00485 1.40976 -325 1 13.1617 7.12114 12.7848 27.9985 9.25187 0.204961 -326 2 14.1485 7.05909 12.8492 -22.0105 -1.86773 -1.16605 -327 2 12.8387 6.22307 12.8528 -4.13181 -6.51108 -0.646654 -328 1 9.62686 1.89618 0.979059 -11.1933 -2.25437 -17.4068 -329 2 8.86583 1.44793 0.536192 15.085 16.0595 8.12302 -330 2 10.1008 2.43338 0.313674 -4.24921 -13.4265 6.88026 -331 1 10.6169 13.5248 4.60784 -18.2432 -3.19473 -12.9411 -332 2 11.3551 12.9251 4.5569 15.1862 -3.85234 3.34493 -333 2 10.6581 13.9134 5.47279 3.49634 8.81883 14.723 -334 1 14.3649 1.74425 10.9305 5.54735 -12.1033 0.31392 -335 2 15.2006 1.47853 10.5325 -1.1471 -9.04293 -1.43649 -336 2 14.4646 2.6903 10.9924 -3.65076 12.6994 -0.169483 -337 1 14.6084 12.2765 11.688 7.48969 -0.0414248 52.7612 -338 2 15.3889 12.4412 11.1797 12.3837 0.874018 -20.9659 -339 2 13.8613 12.0797 11.1652 -22.2598 -6.69151 -32.5036 -340 1 8.22131 5.06515 9.81151 31.4859 -23.4564 -24.7693 -341 2 7.50576 5.35441 10.3398 -29.672 2.17434 15.6894 -342 2 8.09879 4.11038 9.58602 -2.47918 22.6636 6.16193 -343 1 1.53723 16.856 18.3772 -4.91865 -38.0309 19.5229 -344 2 1.81973 17.2424 17.568 8.52952 11.4507 -22.0862 -345 2 1.68062 15.8825 18.2332 -2.55663 27.9439 5.8223 -346 1 1.48989 17.248 15.3251 -39.2991 7.69546 7.77355 -347 2 1.63979 18.1273 15.7491 -10.9611 -20.0854 -9.27397 -348 2 0.505086 16.9983 15.3475 43.8724 16.6347 0.193712 -349 1 3.67894 5.68848 6.10927 6.21387 -9.44646 -9.55971 -350 2 3.15123 6.21186 6.69497 -13.0277 9.84767 14.8728 -351 2 4.18038 6.32117 5.58457 4.58642 -2.3545 -2.10993 -352 1 12.397 9.46521 14.1943 -11.4291 42.6821 2.6577 -353 2 12.6884 8.68898 13.7764 17.0449 -39.3969 -17.6043 -354 2 12.207 9.20402 15.087 -1.24705 -6.16332 16.3323 -355 1 4.0418 15.2774 6.91931 -38.8927 -2.71008 6.44315 -356 2 3.58633 16.0735 6.61178 -2.62598 -4.70343 -0.502904 -357 2 4.94439 15.4914 6.84844 41.7142 6.1892 -4.79175 -358 1 0.605801 8.58372 14.9539 0.254512 0.326548 7.88367 -359 2 0.527439 9.52499 15.1145 -2.4036 7.40824 2.35469 -360 2 1.30759 8.52231 14.3126 8.3049 -1.83762 -9.50966 -361 1 12.9717 8.29262 10.2927 -22.7594 16.3387 10.1639 -362 2 13.6731 7.84025 9.84078 14.5836 -10.6745 -2.92467 -363 2 13.0109 8.02582 11.2281 0.923047 -2.44701 -11.6389 -364 1 15.3232 7.71175 3.53457 4.84131 -0.438878 0.085747 -365 2 14.6048 7.2242 3.18847 -27.3478 1.70601 -26.568 -366 2 15.5504 7.10949 4.22607 20.3905 5.82918 25.2924 -367 1 17.3123 6.68101 0.0543458 25.2448 -11.5383 1.06581 -368 2 16.8643 5.84811 0.208139 -4.52976 -2.78536 3.6701 -369 2 16.6324 7.27442 18.4294 -24.004 18.1506 -8.07094 -370 1 8.88314 6.92259 7.79709 31.0126 27.4325 -12.7619 -371 2 9.82162 7.25311 7.83141 -27.6614 -7.83044 -3.12143 -372 2 8.85418 6.18364 8.38751 -5.1761 -15.9168 16.933 -373 1 12.3742 0.616612 1.23426 0.620177 6.71182 8.7173 -374 2 13.3152 0.448787 1.38768 -5.31542 -0.309906 -0.296651 -375 2 12.0908 0.227811 0.410291 5.35555 -3.35826 -6.33914 -376 1 5.63073 15.1419 14.5354 -14.6404 -24.282 5.65856 -377 2 4.69276 15.2374 14.754 2.80482 -4.42056 0.607876 -378 2 5.89918 16.0006 14.2671 15.2941 25.5531 -11.1631 -379 1 3.85325 6.46699 1.73385 7.01958 -17.0097 2.38606 -380 2 3.51461 7.31896 1.46783 -8.17546 12.9796 -1.79528 -381 2 4.05434 6.54403 2.67764 -3.63249 4.46552 -6.11981 -382 1 3.88854 11.6061 12.3354 -12.5844 1.40703 6.82309 -383 2 4.76337 11.9285 12.5525 8.64878 0.03141 -1.44708 -384 2 3.2838 12.173 12.8501 6.64476 -9.03704 -9.92286 -385 1 5.37483 3.86954 15.8708 7.06931 -74.8011 -5.77053 -386 2 6.14587 3.26348 15.6611 -29.2279 19.2574 6.80998 -387 2 5.70286 4.72315 15.8147 21.5682 55.4234 -2.96121 -388 1 14.3763 10.2794 4.46201 -32.4101 28.4329 49.0365 -389 2 14.443 9.83621 5.32683 0.971611 4.81404 -7.53945 -390 2 14.839 9.74155 3.87936 25.2894 -34.3452 -37.3821 -391 1 7.80918 17.3929 9.15872 22.1479 -28.1908 5.37522 -392 2 6.96403 17.5587 9.551 -17.6194 9.20761 3.63927 -393 2 7.9906 17.9725 8.42371 -6.45863 11.4679 -7.92664 -394 1 4.50911 14.4925 3.93603 -3.72296 -18.8397 -53.7951 -395 2 4.39275 15.3834 4.18687 0.185157 34.2159 14.5975 -396 2 4.6886 13.9787 4.68865 6.61933 -20.0316 37.8242 -397 1 14.2759 7.39669 15.8018 -25.3443 -8.35453 -18.4147 -398 2 15.2098 7.32722 15.7472 31.3188 -3.09541 -3.64929 -399 2 14.1076 7.77613 16.6483 -2.08075 9.82337 20.7866 -400 1 2.98131 18.2876 1.92072 -8.89863 -34.7534 -28.0783 -401 2 2.43865 17.6277 1.38436 23.5626 24.7731 19.3405 -402 2 2.37413 0.302092 2.22775 -14.7638 14.2119 8.82016 -403 1 7.98427 1.62335 4.57287 -40.8947 -0.445207 11.16 -404 2 7.39585 2.15768 4.00383 13.1095 -6.60943 2.01257 -405 2 8.85324 1.63658 4.22836 26.1363 6.2526 -15.7033 -406 1 2.50726 14.1431 17.6951 16.6159 21.4268 -10.1577 -407 2 1.94925 13.5738 18.1946 -18.2656 -19.6261 9.9334 -408 2 3.40865 13.8863 17.9244 2.82527 -4.33175 1.96247 -409 1 0.811695 1.74837 13.8925 -21.7292 3.59652 4.70406 -410 2 0.795118 1.42008 14.8166 -3.87613 7.88135 -16.9479 -411 2 18.5211 1.96459 13.6307 25.6616 -9.0685 11.0917 -412 1 4.4852 18.6484 13.9168 -33.7534 10.3053 3.09674 -413 2 5.3921 18.406 13.9761 25.2496 -8.78408 2.09715 -414 2 4.08373 18.5038 14.7912 8.14506 -1.30426 -6.00867 -415 1 7.12802 0.652367 18.3595 35.0739 -19.2419 -26.0317 -416 2 7.40845 0.19154 17.5185 -9.63956 16.0629 26.4358 -417 2 6.18456 0.683953 18.3433 -21.3742 6.93569 3.25827 -418 1 16.0657 18.4123 14.0301 53.2891 7.60066 12.7833 -419 2 15.2177 18.2242 13.7261 -48.7282 -11.4797 -7.69178 -420 2 16.0808 18.482 14.9966 -9.66087 4.27341 -2.7923 -421 1 10.0672 4.54369 16.2573 46.2132 32.473 -7.3661 -422 2 10.9795 4.93172 16.0704 -30.9355 -10.7562 9.7222 -423 2 10.2805 3.63455 16.4071 -7.05314 -22.7581 -0.39686 -424 1 15.904 17.802 4.45553 44.7656 -19.4466 -14.3322 -425 2 16.4088 -0.0282793 4.41597 5.24747 5.32524 1.83839 -426 2 15.0633 18.045 4.74212 -51.1512 14.4852 15.4733 -427 1 6.99737 17.3998 13.7879 -47.9218 -2.31875 -13.0268 -428 2 7.40243 17.6398 14.5891 19.7576 8.98543 35.5766 -429 2 7.70074 17.2583 13.1843 23.2619 -4.97282 -20.0499 -430 1 13.2941 6.48376 6.64986 8.60711 15.0683 16.7306 -431 2 13.9993 7.1541 6.49159 -11.9149 -19.7057 -4.80273 -432 2 12.8211 6.29295 5.83939 3.46216 6.87198 -11.4398 -433 1 7.76205 2.3443 9.26472 15.7579 10.991 45.3998 -434 2 7.20759 2.25447 10.0765 8.01487 -1.94761 -18.5756 -435 2 7.26048 2.06297 8.52639 -23.6607 -10.4133 -22.8687 -436 1 15.1706 14.8583 13.6757 15.7984 -16.1031 1.44613 -437 2 15.0167 15.231 14.5413 -6.09806 3.71972 9.46304 -438 2 14.6225 15.2955 13.0407 -11.5903 11.1836 -9.13521 -439 1 9.36431 8.31687 3.74781 -9.55399 11.9025 -3.42765 -440 2 10.1518 8.60925 4.20014 9.2003 9.72282 -0.0746101 -441 2 9.3553 7.37835 3.87681 -0.285781 -17.995 1.20514 -442 1 17.7597 13.5616 16.4405 -12.156 -24.6438 9.82021 -443 2 16.8551 13.2283 16.3395 1.48334 1.58847 4.06975 -444 2 17.7289 14.3961 16.0037 5.37456 23.0458 -12.1714 -445 1 4.95841 10.6088 2.75519 -22.9294 18.7883 -14.1686 -446 2 5.66909 10.277 3.27928 16.3083 -8.75526 16.0734 -447 2 4.6114 11.3873 3.23357 6.81328 -15.8641 -4.024 -448 1 3.73362 8.35206 10.1813 3.02598 13.3252 -21.6654 -449 2 3.8939 9.27056 9.86724 -4.6548 -13.2191 9.23973 -450 2 3.49789 8.39898 11.1021 -0.178845 4.23779 13.7606 -451 1 16.0042 7.01418 6.13738 -12.6879 19.8807 -2.17242 -452 2 16.808 7.4479 6.40937 10.6213 6.47779 2.98579 -453 2 16.2019 6.09716 6.06821 5.44302 -25.895 -2.3467 -454 1 15.1221 7.07483 9.10103 -4.15707 -25.1338 32.4641 -455 2 15.7464 7.4872 9.69859 9.03801 3.43378 3.13104 -456 2 15.1481 7.58948 8.33098 1.37226 23.8896 -40.0507 -457 1 6.35284 13.0135 12.8052 -0.193314 -18.9728 -17.7547 -458 2 7.21044 12.6571 13.0708 -4.00291 0.344811 4.20755 -459 2 6.11805 13.741 13.3614 0.492624 18.505 17.8288 -460 1 12.1195 4.49733 13.0969 -26.0004 -21.5883 -29.3264 -461 2 12.1632 4.68913 14.0325 -4.53328 -3.39715 11.6105 -462 2 11.3073 3.93318 12.8667 31.5163 26.387 18.3053 -463 1 11.3554 8.17046 7.8728 -3.27026 2.45633 -4.65198 -464 2 12.0683 7.62612 7.54639 6.23155 -9.6048 -12.5756 -465 2 11.5676 8.24955 8.79484 1.17104 5.44951 18.1694 -466 1 17.1791 10.8374 7.47157 -22.685 17.097 10.0101 -467 2 17.8401 10.2117 7.26521 25.6893 -28.4186 -0.815308 -468 2 17.2004 11.4333 6.72646 -9.08817 8.64759 -4.95169 -469 1 5.26928 18.1244 11.0251 26.2987 0.0330793 2.18763 -470 2 4.69547 17.8637 11.7317 -9.61751 -4.26247 14.7568 -471 2 4.70076 18.4264 10.3375 -16.9 2.57743 -21.8459 -472 1 7.59635 17.5306 1.81531 -10.9531 4.1869 -25.2725 -473 2 7.77056 16.6988 1.31883 2.24077 21.8764 10.5056 -474 2 7.30155 18.2046 1.15131 11.3055 -17.5184 13.1347 -475 1 1.92843 12.8944 13.5862 -6.59595 -16.5477 -16.8116 -476 2 1.43666 12.2821 14.1316 -5.58333 -5.88714 5.06202 -477 2 2.04362 13.6601 14.1181 9.10211 24.5058 14.6097 -478 1 9.63922 6.76943 14.8194 -3.94612 -18.0692 3.52162 -479 2 9.76751 5.80583 15.0218 -0.27339 26.7602 -8.06829 -480 2 9.98245 6.98264 13.9392 -2.96138 -9.43899 0.82382 -481 1 15.2804 4.29771 10.7711 -7.29951 -1.41697 -0.334277 -482 2 16.1821 4.02615 11.0218 -9.71269 11.8498 1.69675 -483 2 14.9105 4.9568 11.3864 17.8049 -7.45406 -3.59162 -484 1 11.2365 6.16159 0.180514 3.71779 6.92115 0.875598 -485 2 11.3264 5.36714 18.3195 14.2335 -18.3801 -6.22284 -486 2 10.2946 6.26806 0.197414 -17.1549 12.9032 2.71424 -487 1 0.0669242 11.3685 15.0652 13.212 -6.85086 18.3683 -488 2 18.0421 11.4114 14.3938 -11.7915 7.94746 -16.0964 -489 2 -0.126536 12.1197 15.6445 1.80559 0.362507 -3.06694 -490 1 7.04679 9.22841 7.26069 23.2883 20.8536 -5.26127 -491 2 6.49897 8.58869 7.67863 -15.4435 -25.8158 9.46312 -492 2 7.95399 8.89143 7.34084 -8.97527 1.37154 -2.4384 -493 1 18.3457 15.377 12.3544 -10.4554 -0.385944 -2.00928 -494 2 0.632165 15.4053 12.1583 18.2501 2.20759 0.366712 -495 2 17.9344 15.8751 11.6412 -4.56296 -0.981709 -1.73702 -496 1 16.5292 4.37759 5.24858 18.1125 19.5767 -27.8403 -497 2 16.7661 4.20984 6.14013 0.307987 -10.9951 33.7785 -498 2 17.3779 4.70209 4.86684 -19.0742 -11.8317 -4.1687 -499 1 17.7267 3.12899 10.7335 -24.2941 -12.2101 -5.28174 -500 2 18.5902 3.43151 10.9823 20.7538 0.196381 3.18907 -501 2 17.7917 2.2294 10.3565 4.74658 11.2046 4.02468 -502 1 12.2912 0.000462328 10.1205 5.29277 -42.3116 -12.7781 -503 2 11.463 0.345322 10.3908 -30.9755 9.64408 8.62664 -504 2 12.8898 0.704281 10.2182 28.9402 34.0259 3.93413 -505 1 10.3772 9.78855 12.3993 -21.9688 -12.411 -17.7787 -506 2 11.0129 9.78765 13.1014 16.013 1.76066 13.7043 -507 2 10.1738 8.8461 12.2399 4.72709 11.7982 0.616329 -508 1 0.569471 2.8284 7.02034 6.04311 -30.2491 -2.51113 -509 2 0.820763 3.41522 7.71636 2.48105 19.4463 13.5049 -510 2 0.862153 1.97327 7.38155 -6.15059 8.48947 -7.95665 -511 1 0.371359 15.3036 6.90441 -15.8595 21.8666 50.0789 -512 2 0.449232 14.6844 7.65301 -0.190166 17.9034 -2.10351 -513 2 0.621967 14.7945 6.18679 16.5003 -37.2512 -48.0182 -514 1 17.0414 7.00877 15.2159 -22.6634 4.89001 -1.64325 -515 2 17.7376 7.6544 15.0563 8.01654 -6.9456 2.15019 -516 2 17.4056 6.16817 15.5101 9.28872 0.897926 -1.45041 -517 1 9.06316 12.4266 8.08985 69.8766 6.47542 -0.0200154 -518 2 9.44101 11.8026 7.43298 -17.7999 4.13897 6.91255 -519 2 8.14431 12.4062 8.1331 -54.6706 -8.19385 -9.80298 -520 1 1.26891 1.85581 2.9921 11.7044 -8.67905 12.4997 -521 2 0.561231 2.0509 2.38915 -6.84046 11.4219 -12.1453 -522 2 1.65109 2.68456 3.32008 -5.2596 -5.54909 -2.36563 -523 1 4.11753 15.1048 9.79523 4.78264 -4.87511 12.6416 -524 2 3.99332 15.4569 8.91057 5.07926 -2.88804 -4.85995 -525 2 5.03278 14.7822 9.88586 -9.66079 5.58119 -5.37355 -526 1 7.25278 2.18203 14.6254 -0.555581 -14.0599 -5.06396 -527 2 7.1005 1.71681 13.7878 -2.90711 2.6098 7.34806 -528 2 7.71992 2.97108 14.3713 4.55177 12.8631 -2.10328 -529 1 18.557 14.6494 2.1729 -24.7771 22.3853 -4.36836 -530 2 0.778963 15.0461 2.09778 12.8139 1.02797 3.11036 -531 2 17.9275 15.4159 2.12338 10.4684 -24.8222 2.25012 -532 1 9.97282 2.76121 12.909 0.960373 12.9666 17.7509 -533 2 9.84581 2.0662 12.2717 -5.76657 -8.74665 -14.3806 -534 2 9.17654 3.31629 12.9308 6.08178 -3.78367 -5.74316 -535 1 2.89833 8.91803 13.044 14.9503 3.68581 0.826535 -536 2 3.29774 9.80788 12.9186 -7.17545 -13.4779 0.185991 -537 2 3.62224 8.34145 13.3619 -7.75262 8.46695 -4.72395 -538 1 3.21711 8.45664 3.69888 -1.45646 11.2765 -73.7917 -539 2 3.66926 9.20612 3.219 -10.9411 -20.3742 19.6072 -540 2 3.34915 8.55803 4.60102 11.7629 13.1896 57.1484 -541 1 5.60205 7.18882 8.56127 11.7766 6.17403 -13.6051 -542 2 5.73377 6.23122 8.60856 -5.21401 3.91262 5.39773 -543 2 5.15686 7.50265 9.34977 -6.87961 -7.75657 6.1504 -544 1 14.8989 1.38427 1.96946 -15.0866 25.6457 3.84218 -545 2 14.4906 2.19786 2.32837 7.96598 -16.9425 9.74227 -546 2 14.9786 1.62425 1.05302 13.5137 -6.97514 -15.0219 -547 1 8.3539 15.1902 0.828571 -0.607384 -15.7884 -3.69873 -548 2 9.11456 14.9295 1.35098 9.06641 9.90213 6.9538 -549 2 7.64957 14.6447 1.20074 -5.27592 0.575252 -4.39528 -550 1 15.5904 1.35118 7.21966 19.131 18.1941 14.0102 -551 2 15.0458 0.788774 6.70847 -19.486 -21.9805 -16.5491 -552 2 15.0172 2.08736 7.44992 -1.58717 6.06663 4.11757 -553 1 4.99095 13.0428 18.5017 -11.814 -5.03203 -22.7016 -554 2 5.38558 13.1981 0.699871 9.67176 2.40993 22.9792 -555 2 5.69857 13.2122 17.8695 -3.662 3.61759 -0.881885 -556 1 15.3616 8.52427 18.1264 -8.5134 -8.81723 23.808 -557 2 15.7284 8.98559 17.3934 10.1937 15.818 -24.0842 -558 2 15.2728 9.20414 0.16849 -1.83009 -5.75583 -0.912989 -559 1 12.0932 3.04939 18.3516 -14.5656 24.4873 8.42937 -560 2 12.4759 2.51827 0.417994 -2.38649 -9.33387 -9.98316 -561 2 12.2916 2.69447 17.4847 9.72648 -15.0074 2.48816 -562 1 13.2068 12.6815 5.17314 -7.19784 6.47098 -0.665029 -563 2 13.7108 11.8878 4.96601 4.53767 0.295949 3.70661 -564 2 13.3847 12.9363 6.09127 2.00425 -11.4311 -4.02895 -565 1 6.06883 7.14745 0.0914664 -7.81354 22.5487 2.98517 -566 2 5.88319 8.11419 0.19427 8.4279 -22.2037 -4.79949 -567 2 5.22519 6.72532 0.292473 3.10856 -0.243494 3.48057 -568 1 17.7194 15.9325 14.9871 -5.54638 -4.40987 -28.7902 -569 2 16.9069 16.4169 14.9498 -12.3977 10.2544 17.1316 -570 2 17.7594 15.7087 14.0393 19.0068 -3.79668 12.8095 -571 1 13.1727 0.977833 16.5926 -11.6444 6.00991 -1.45652 -572 2 14.0026 0.708875 16.9779 14.0624 -0.886732 -0.671765 -573 2 12.7076 0.152182 16.4397 -1.15444 -5.20647 -2.10321 -574 1 11.0384 14.6069 7.3103 -17.4066 -34.6271 2.52502 -575 2 10.2783 14.0261 7.58336 17.6612 20.778 -3.294 -576 2 11.8174 14.0391 7.44317 -4.14385 7.222 1.39489 -577 1 17.5379 8.55913 2.08836 4.35413 -11.6997 -13.5411 -578 2 16.664 8.39738 2.48219 7.20941 -2.48593 -6.20174 -579 2 17.6519 7.91106 1.34391 -7.20398 14.5397 25.454 -580 1 12.3635 7.91649 1.96817 14.6342 -23.934 -0.413214 -581 2 11.8532 8.69875 2.12901 -10.659 13.0689 -1.52352 -582 2 11.9409 7.3888 1.27378 0.548374 7.65925 3.61612 -583 1 11.9419 14.6308 10.3966 13.4402 32.5881 48.4479 -584 2 12.2905 14.0069 9.8182 12.9115 -34.2012 -37.3181 -585 2 11.0351 14.785 10.1903 -23.9611 0.860738 -9.13817 -586 1 6.84298 6.98317 15.5594 -28.1276 -29.1686 -18.0428 -587 2 7.705 6.91496 15.176 20.6419 5.27277 -3.3528 -588 2 6.85291 7.68491 16.1747 6.25697 23.8787 22.837 -589 1 8.01998 4.63032 13.4448 -35.0292 -26.7707 -36.5428 -590 2 7.42844 4.80515 12.6548 14.5268 -5.56395 32.2217 -591 2 8.43798 5.44118 13.6312 16.8653 30.885 3.99265 -592 1 13.3984 12.173 14.3104 -3.57217 10.7678 8.64565 -593 2 13.233 11.2355 14.1881 -1.19303 -4.98427 -3.70246 -594 2 13.8945 12.4998 13.5522 0.86121 -3.67781 -4.0367 -595 1 14.7231 9.47939 7.26845 -4.38272 9.59825 17.375 -596 2 15.5232 10.0108 7.49545 -18.3981 -9.5314 -3.88615 -597 2 14.0057 9.68134 7.91225 20.1628 1.06432 -13.939 -598 1 12.7179 16.9622 3.14627 23.4566 -37.2939 -10.6207 -599 2 12.9355 17.1415 4.04114 9.03221 7.6908 26.6047 -600 2 12.0213 17.5358 2.94483 -34.3001 33.1559 -14.5415 -601 1 1.10947 7.12267 17.419 -6.10821 -8.12856 16.9857 -602 2 0.178422 7.136 17.6887 4.23762 -2.5375 0.360706 -603 2 1.14096 7.54201 16.5672 -1.29203 8.00191 -14.7545 -604 1 12.8573 5.07319 15.6916 -26.4132 -0.426227 -0.347566 -605 2 13.5067 4.42508 15.4662 18.5417 -18.6841 0.103563 -606 2 13.3354 5.89586 15.6754 6.08426 15.3432 1.29959 -607 1 2.44451 3.37888 5.09109 -12.3042 -30.7639 -30.2825 -608 2 1.89914 3.20439 5.84354 -15.8924 -6.60657 16.2411 -609 2 2.9157 4.14854 5.30475 25.2943 38.046 11.4255 -610 1 8.30318 11.1757 13.537 -17.7368 31.3122 -83.5918 -611 2 8.23756 10.9827 14.4193 9.23305 -26.2584 72.471 -612 2 8.98641 10.7011 13.0548 11.9243 -7.18625 13.6047 -613 1 12.9121 1.44799 13.2982 3.17544 -30.959 19.595 -614 2 13.5829 1.31511 12.6431 13.7174 -5.57278 -14.8203 -615 2 12.5671 2.27513 13.0597 -18.9903 37.7092 -4.23536 -616 1 6.45025 13.6395 2.14169 21.7214 -12.6454 -10.4453 -617 2 5.88722 14.0323 2.78408 -20.3944 14.637 16.9787 -618 2 7.03563 13.0797 2.67163 0.317992 1.20831 -5.89746 -619 1 15.9341 6.54969 12.734 7.51439 18.2634 -8.82177 -620 2 16.366 7.12442 12.0552 -8.93517 -14.9663 18.1444 -621 2 16.3202 6.79095 13.5987 -1.79943 -6.04596 -11.4359 -622 1 16.8134 0.715269 9.59469 1.51011 24.5111 -1.75686 -623 2 16.9773 18.4324 9.6759 -2.99022 -25.9416 6.21625 -624 2 16.4855 0.841275 8.69831 -5.26956 1.43879 -3.58435 -625 1 6.14183 11.6821 8.34851 2.12045 33.7206 2.80541 -626 2 5.25373 11.5769 8.68031 -11.2997 -2.21294 6.8592 -627 2 6.41363 10.8186 8.10997 12.8023 -29.2169 -10.6172 -628 1 2.82878 8.69633 0.366162 65.7357 7.98524 25.914 -629 2 2.25196 8.1872 18.4995 -43.1364 -19.0897 -25.1642 -630 2 2.39827 9.3921 0.850531 -20.8372 5.7472 0.329713 -631 1 10.1125 10.4546 6.55694 -3.88563 -4.31924 12.8938 -632 2 10.5628 9.81084 7.11921 -1.26662 -0.776779 -0.718706 -633 2 10.7076 10.6109 5.83303 6.58413 -0.38446 -16.1853 -634 1 6.75197 15.7318 6.59922 10.1749 2.21511 -7.15796 -635 2 7.21229 16.0038 7.38721 0.121014 2.00215 12.9298 -636 2 7.17446 16.2736 5.9175 -9.12202 -3.23328 -2.5626 -637 1 6.44006 13.071 5.66115 9.01876 9.03356 -0.68679 -638 2 6.7952 13.9213 5.9766 -6.67057 -7.15315 -1.80184 -639 2 6.02558 12.6573 6.41982 -1.29087 -3.79345 3.79648 -640 1 16.7894 12.5351 9.7661 -6.01106 14.3853 23.3751 -641 2 16.9466 11.9627 9.02496 7.22561 -5.83165 -16.8213 -642 2 17.1452 13.4178 9.59292 -0.312151 -9.66884 -5.48162 -643 1 6.11103 2.94777 2.80745 -0.0522908 21.1759 -16.381 -644 2 6.20729 3.87808 2.49328 4.01665 -19.1858 15.5438 -645 2 5.82625 2.47942 2.01203 -2.73031 -5.31149 4.59086 -646 1 10.8562 3.22295 3.2592 5.83487 -6.01133 1.10343 -647 2 10.3184 3.99141 3.45824 -8.06424 0.347936 -1.44444 -648 2 10.5285 2.8344 2.43843 -2.26863 2.18612 2.83427 -ITEM: TIMESTEP -50 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.76267 6.9614 17.9655 18.039 1.32171 0.971735 -2 2 7.88851 7.04905 18.3237 -17.7355 -1.2272 4.07533 -3 2 8.77103 6.18416 17.4071 -1.73171 -4.43635 -4.46665 -4 1 18.7148 8.30367 6.79977 -11.0979 19.7573 -45.8218 -5 2 0.340011 8.13606 5.84126 -7.49685 -0.624375 38.3142 -6 2 0.514278 7.70743 7.38333 14.5888 -19.2797 9.57425 -7 1 8.47639 18.6969 6.83361 -13.2294 -1.25401 8.78355 -8 2 9.37315 0.218195 6.58559 19.0885 2.32763 -3.91705 -9 2 7.98208 0.748711 6.39478 -2.33131 3.58411 -1.86541 -10 1 6.52812 1.78346 11.693 -34.4751 -1.18092 9.20038 -11 2 5.67737 2.21709 12.0036 34.6116 -15.9045 -8.19534 -12 2 6.27488 0.856486 11.479 2.31906 19.7771 3.09659 -13 1 7.04596 5.66579 2.40189 46.2065 -42.3734 -14.42 -14 2 6.39782 6.00892 2.95716 -37.9245 28.3982 32.5204 -15 2 6.93615 6.04049 1.54428 -8.317 15.9019 -18.5798 -16 1 16.2302 10.236 16.0835 20.9593 -16.5275 2.4245 -17 2 17.1756 10.4542 16.2372 -23.2351 0.455296 -7.02457 -18 2 15.6872 10.9657 16.3738 0.757377 12.3052 3.78761 -19 1 10.6519 14.9414 2.32488 9.23959 14.6152 1.78567 -20 2 10.6414 14.4628 3.16471 0.797937 2.29677 -5.70575 -21 2 11.1604 15.7599 2.50148 -7.89724 -14.8548 -1.26363 -22 1 17.1653 8.24769 10.628 -7.00673 -3.15457 9.83212 -23 2 16.8168 8.85992 11.2947 -1.87186 0.196375 -6.64951 -24 2 17.9222 8.68524 10.2369 7.99899 3.60318 -1.68622 -25 1 14.7266 15.9157 16.4191 -13.8739 15.1565 -8.48964 -26 2 13.7936 16.2384 16.3951 24.1732 -8.40377 0.758561 -27 2 14.8582 15.5746 17.3097 -4.06225 -5.68183 -0.795501 -28 1 12.1165 13.3951 0.497647 12.4663 -12.7582 1.83308 -29 2 11.9617 13.3954 18.1814 -7.51799 5.11576 7.21512 -30 2 11.4424 13.8646 1.00511 -0.599491 5.86198 -7.65109 -31 1 9.3022 5.46358 3.98483 37.3 9.28522 -25.3544 -32 2 8.76176 5.25183 4.70521 -26.4917 -13.7331 37.3539 -33 2 8.69012 5.59126 3.27137 -14.2398 -0.31671 -15.324 -34 1 1.75646 4.13824 11.6126 7.13571 -34.631 6.10286 -35 2 1.57168 5.01735 11.8974 -3.49495 27.0073 7.26754 -36 2 2.15491 3.66767 12.3745 -6.50879 7.63382 -13.9832 -37 1 2.03017 6.80422 8.30837 9.29028 16.8447 12.8872 -38 2 2.52076 7.32809 8.97976 -10.1379 -7.93343 -11.4013 -39 2 1.79129 5.98703 8.76166 3.66627 -1.3648 -7.3534 -40 1 5.38278 4.45139 7.96045 1.48715 2.78745 -0.615366 -41 2 5.47525 3.53905 7.69237 2.73507 -15.0654 6.73754 -42 2 4.91072 4.84535 7.233 -11.388 9.54401 -10.9371 -43 1 3.30811 2.94776 17.4802 13.944 -42.282 -21.1312 -44 2 3.9986 3.21817 16.868 2.68053 3.29728 -0.298822 -45 2 3.01647 3.72731 17.8911 -19.397 34.8415 21.3069 -46 1 7.43048 5.35311 6.10326 -4.25319 -13.0158 -27.7806 -47 2 8.09022 5.89476 6.48364 23.034 26.3027 15.5228 -48 2 6.99872 4.97144 6.84559 -15.3695 -14.0963 19.964 -49 1 9.79676 7.01231 12.0156 -14.7328 3.59156 -15.7655 -50 2 10.3705 6.43202 11.4882 -9.23999 6.31012 5.56299 -51 2 9.04301 7.2927 11.4294 23.3546 -9.34629 13.9639 -52 1 14.0089 3.6286 8.06931 13.5755 5.11429 34.4728 -53 2 14.0074 4.36435 7.46412 -2.30693 7.62473 -7.33974 -54 2 14.3705 4.00595 8.91563 -10.4749 -13.1534 -24.8623 -55 1 4.55657 17.1558 3.95973 -9.28017 -24.3455 25.7085 -56 2 5.47914 17.3407 4.055 21.0307 11.7367 -4.03215 -57 2 4.1348 17.6911 3.31263 -3.95253 16.2794 -25.0192 -58 1 16.4751 16.614 10.2504 -32.3258 -7.85569 21.4695 -59 2 15.6275 16.6356 10.7813 29.977 2.99208 -16.9651 -60 2 16.2718 15.9944 9.53771 -1.01186 4.78751 -1.5712 -61 1 1.9619 4.81867 0.319959 -10.9755 -9.70287 -18.0846 -62 2 2.61752 5.08919 0.942567 15.1261 9.15008 18.4356 -63 2 1.74644 5.61951 -0.161427 -5.07436 5.04444 -4.19633 -64 1 11.5961 13.2841 16.3358 -4.45358 14.5896 10.2849 -65 2 11.0454 12.5131 16.3954 -10.7816 -16.1685 4.94665 -66 2 12.1536 13.1064 15.5876 11.3576 1.56581 -12.6168 -67 1 10.1325 11.0245 16.8746 -17.0839 37.329 0.881875 -68 2 10.5383 10.188 16.8005 14.1256 -36.2582 -1.95739 -69 2 9.19072 10.9065 16.7053 -0.138929 -3.60954 1.11764 -70 1 11.7656 17.449 13.475 -8.50487 25.248 2.18402 -71 2 12.3632 17.1066 12.8073 4.24528 -3.45864 -2.0733 -72 2 11.8231 18.4283 13.4081 4.57434 -16.4673 0.201387 -73 1 6.41878 9.35136 12.2283 -7.50229 14.2202 21.4939 -74 2 6.8057 8.89086 11.4896 12.6266 0.651555 -6.79619 -75 2 7.09031 9.88696 12.7035 -9.91308 -10.3657 -12.0835 -76 1 16.2619 12.8358 2.69678 7.42582 31.4023 -4.83963 -77 2 17.0939 13.3284 2.51069 -14.3032 -16.3414 4.28546 -78 2 15.5824 13.5473 2.68145 7.19887 -17.4175 4.43499 -79 1 0.698809 12.6212 5.89369 35.48 3.16674 13.5988 -80 2 0.938081 12.5288 4.97754 4.92149 -4.10163 -12.4931 -81 2 18.4194 12.7439 5.90006 -39.8609 3.63618 -4.1467 -82 1 5.237 16.4363 18.426 1.65878 -0.316472 9.22308 -83 2 5.81108 15.7548 18.0954 4.21498 -13.4949 -13.2329 -84 2 5.56972 16.5656 0.670239 -4.67124 7.34541 5.05152 -85 1 0.592121 7.69947 4.15467 -58.6061 -26.6762 36.9237 -86 2 18.6393 8.0928 3.5307 -12.7545 6.31849 -14.8448 -87 2 1.4218 7.85573 3.82511 72.6481 19.3185 -25.9209 -88 1 3.11983 8.96532 6.48794 54.6199 12.7003 -22.2767 -89 2 3.76913 8.45297 6.98254 -4.7725 1.8296 2.92636 -90 2 2.27977 8.75705 6.803 -46.0396 -12.4219 19.8369 -91 1 7.29807 10.3702 16.2638 20.6686 -0.114663 -24.6428 -92 2 6.66655 10.506 15.5642 -5.16108 2.7891 -5.34334 -93 2 6.78521 10.2638 17.0451 -10.3715 -1.64006 24.8745 -94 1 11.1174 0.987619 5.00277 -7.18116 3.53088 7.25248 -95 2 11.0089 1.86145 4.60844 7.25629 1.31859 -0.585836 -96 2 10.7387 0.391071 4.35918 -2.65397 -7.99376 -8.61355 -97 1 4.35641 2.82374 13.2083 -1.43301 42.1246 -29.6721 -98 2 4.74578 3.12447 14.0221 1.91906 -0.955597 13.0676 -99 2 4.17771 1.91012 13.264 -5.21231 -41.1093 14.0839 -100 1 8.41102 10.1748 1.81577 -7.29686 12.4487 -22.3398 -101 2 8.22152 10.8552 2.46036 0.4991 6.95458 5.373 -102 2 8.69583 9.43786 2.3232 10.7851 -24.1065 14.6426 -103 1 10.4306 1.70557 15.5491 18.4702 5.47966 -9.86629 -104 2 11.3921 1.67519 15.3716 -14.7227 -5.4908 8.94093 -105 2 10.0695 2.09393 14.7416 -3.28742 -2.92827 -1.64813 -106 1 2.67775 12.9037 7.82287 3.09642 7.69249 12.8714 -107 2 3.27779 13.5956 7.51776 -0.922255 -1.64886 -5.76029 -108 2 2.01429 12.7843 7.13996 -0.0248334 -2.64481 -5.98892 -109 1 3.74038 11.6511 5.07858 19.3958 17.4162 2.05128 -110 2 3.60589 10.7736 5.39333 -4.06789 -18.6575 13.0804 -111 2 3.07486 11.8033 4.42286 -17.2397 4.77378 -8.56343 -112 1 6.72135 14.4316 16.9296 11.8603 14.2358 -0.0778856 -113 2 7.64698 14.6853 17.0511 -5.38436 -3.23295 2.03342 -114 2 6.43726 14.8986 16.1349 -2.65892 -7.20284 -3.09426 -115 1 14.1884 14.544 3.35185 -21.8252 -0.368401 10.0779 -116 2 13.5247 15.1958 3.05461 14.5314 -4.887 4.26149 -117 2 13.7567 14.0734 4.09815 10.0173 4.52685 -16.1607 -118 1 8.41325 18.11 16.0503 -13.4237 14.7481 -2.40694 -119 2 9.01353 17.4146 16.1754 14.4883 -45.0972 12.851 -120 2 9.02228 0.139466 15.7926 3.66197 31.0187 -5.55304 -121 1 4.74026 1.68368 4.91774 -8.81747 -38.2992 48.653 -122 2 3.89365 2.07173 5.09257 -16.8489 9.86366 -0.181142 -123 2 5.05165 2.08173 4.1548 23.8621 30.7653 -48.3713 -124 1 15.012 12.6397 16.4637 21.182 -20.8114 -27.7575 -125 2 14.6363 13.1316 17.1743 -19.1608 12.2632 11.0748 -126 2 14.4002 12.4571 15.7145 4.23163 12.8017 20.733 -127 1 15.7141 18.464 16.8736 -48.8091 1.63943 -48.6642 -128 2 16.4537 18.5656 17.3974 52.451 1.55627 42.8989 -129 2 15.6088 17.527 16.6934 -4.99653 -8.13868 6.26406 -130 1 1.24245 1.19714 16.5568 -3.35795 -9.15112 -9.15157 -131 2 2.06126 1.67967 16.5955 12.2536 9.19 1.95012 -132 2 0.738255 1.56007 17.2754 -9.1343 5.49748 13.2621 -133 1 18.1403 4.48045 15.9024 -8.92064 9.41796 12.6958 -134 2 18.2534 3.91822 15.1507 3.10214 -9.7063 -13.7449 -135 2 0.333051 4.53253 16.3579 6.8431 0.540548 1.72555 -136 1 12.2576 16.9773 16.1451 24.3374 26.4028 -39.8206 -137 2 11.5235 16.7559 16.6626 -39.484 -19.8089 22.2101 -138 2 11.9275 17.1263 15.229 8.36672 -7.61232 16.8746 -139 1 16.0311 2.54163 18.1267 15.2184 -17.5558 18.8253 -140 2 15.6351 3.35325 18.4083 -9.02057 20.5203 4.48377 -141 2 15.9018 2.48695 17.1953 -7.32995 1.76863 -25.4669 -142 1 6.72575 13.8191 10.1968 -9.26978 -14.9128 -14.7006 -143 2 6.45064 13.4802 11.0509 2.35225 3.79258 9.11016 -144 2 6.47529 13.1065 9.58166 7.75573 8.69288 2.20437 -145 1 10.1667 18.3423 2.73278 -21.0918 -24.4685 17.5154 -146 2 10.3808 0.422697 2.17354 8.51297 19.7321 -20.8009 -147 2 9.25877 18.0911 2.47579 12.4496 3.13566 3.08398 -148 1 3.02618 17.7182 6.12046 9.12785 6.17449 -5.85825 -149 2 2.19895 17.4959 5.67953 0.482163 3.05546 -3.6427 -150 2 3.66706 17.9189 5.4073 -11.2068 -9.39986 11.0759 -151 1 12.5962 16.8879 7.98687 8.69067 0.386489 -7.96768 -152 2 11.911 16.2378 7.93697 -12.2796 -18.2514 -9.64148 -153 2 12.3467 17.3792 8.75804 4.49939 18.0195 12.184 -154 1 14.8895 15.2713 8.19847 3.78441 6.77747 -24.1674 -155 2 14.0908 15.8092 8.10802 0.530475 -1.70182 9.59272 -156 2 15.3507 15.4528 7.3473 -4.11878 -7.96121 22.2836 -157 1 17.7044 18.2264 0.345927 53.2191 22.2557 3.1655 -158 2 18.611 17.8064 0.306571 -34.334 1.581 -6.33561 -159 2 17.9464 0.534475 0.465882 -17.8927 -21.106 -0.514669 -160 1 0.816649 10.4426 1.34739 14.8692 48.9775 -23.6448 -161 2 0.0612409 10.0129 1.68761 -29.4632 -23.0248 11.5333 -162 2 0.465717 11.2339 0.843051 15.2672 -28.7963 15.4324 -163 1 1.72991 12.2406 3.39174 -15.9976 -2.88445 -44.3457 -164 2 1.42407 11.5936 2.70825 8.45982 5.87631 22.8389 -165 2 1.72198 13.0652 2.87637 5.68226 -3.3333 12.0496 -166 1 0.611993 17.231 4.90821 -34.3512 10.3394 53.8078 -167 2 18.7649 18.0776 4.93361 14.0145 -8.94618 -14.8948 -168 2 0.320128 16.8659 5.79609 20.9887 -2.41003 -36.5782 -169 1 1.10304 0.897417 9.42158 -11.0752 -12.4205 -5.86027 -170 2 1.33193 0.471936 10.271 -7.8206 6.77035 -10.9921 -171 2 0.260273 0.49253 9.11811 18.1645 10.0729 11.6017 -172 1 16.7431 2.34345 13.2996 -3.12231 -7.25082 27.0749 -173 2 16.9139 2.55723 12.403 6.00909 8.65593 -29.5603 -174 2 16.479 1.41627 13.3001 1.0866 -1.80785 3.13205 -175 1 2.64585 15.864 12.1283 -21.2463 14.7527 -7.08654 -176 2 3.15605 15.3934 12.7599 11.6364 -10.3414 18.5671 -177 2 3.00262 15.6045 11.2815 4.79088 -2.17896 -11.8296 -178 1 16.4298 15.6598 6.07287 -23.7839 -45.9221 18.6798 -179 2 17.316 15.6562 6.39936 21.0579 5.20152 4.08476 -180 2 16.3078 16.3335 5.44341 2.1367 33.4546 -25.3893 -181 1 5.80337 5.0927 11.7988 -16.1764 10.2154 8.68093 -182 2 5.24436 5.75105 12.277 17.1169 -11.9851 -7.24057 -183 2 5.28663 4.27668 11.796 1.81497 4.13117 2.00496 -184 1 15.1635 4.86687 0.779797 10.276 15.6296 -42.8981 -185 2 15.0374 4.47718 1.61189 -4.55383 -15.7546 43.9488 -186 2 14.356 5.34586 0.597493 -2.57536 1.02491 -2.93315 -187 1 16.3458 16.3763 2.04771 3.47576 3.66541 23.8501 -188 2 16.2044 16.7006 2.97252 -3.72753 -7.68524 -25.3267 -189 2 16.7389 17.1226 1.58867 -0.552753 3.82143 -4.99822 -190 1 0.255881 4.83863 3.82235 -11.3764 -61.9515 -5.66134 -191 2 0.347221 5.7447 3.93716 8.7619 60.1171 8.48532 -192 2 0.834328 4.39842 4.45398 2.37129 4.71095 -1.99834 -193 1 2.9563 15.0569 15.1257 1.71124 8.82343 -41.1566 -194 2 2.85861 14.8634 16.033 -5.32392 -14.5435 34.6784 -195 2 2.48389 15.8911 15.0234 3.12674 0.885842 0.387353 -196 1 1.13777 14.6522 9.5263 -30.3315 0.106042 24.0606 -197 2 1.89024 14.3075 9.07024 17.4708 -15.5826 -4.95385 -198 2 0.933623 14.0402 10.2733 8.29602 9.54759 -23.1661 -199 1 13.5292 16.584 11.5416 25.6454 -21.6132 21.0377 -200 2 13.328 17.2834 10.9465 -13.4726 19.9213 -18.5602 -201 2 13.2496 15.765 11.1158 -9.99742 3.11837 -0.28929 -202 1 4.66126 1.44669 0.76776 24.0608 13.759 -10.2694 -203 2 4.19513 2.00271 0.14116 -5.95148 5.85957 -2.67997 -204 2 4.06121 0.755814 1.00952 -11.6339 -11.0076 11.757 -205 1 1.46276 18.5641 11.8468 9.16484 -20.9655 21.4802 -206 2 1.29795 0.448688 12.6433 2.09315 -1.75191 -4.75625 -207 2 1.84947 17.7191 12.1761 -6.39306 18.521 -9.12508 -208 1 11.4915 10.1299 3.99438 -29.0311 -19.3551 44.8744 -209 2 11.2201 10.4871 3.17848 -8.25775 15.5063 -35.6965 -210 2 12.4189 10.233 4.02648 37.0944 1.09916 3.99775 -211 1 8.27499 12.1796 3.66337 18.6814 -7.12196 -36.2468 -212 2 9.0689 12.5922 3.98877 11.875 7.24467 3.22649 -213 2 7.6764 12.2152 4.36849 -32.1167 2.17346 40.1921 -214 1 14.4874 4.01368 3.28039 -17.5005 -0.0616197 -21.9184 -215 2 14.9648 3.93911 4.08552 21.5727 -0.139675 21.9436 -216 2 13.7566 4.60071 3.48465 -5.84393 1.34015 1.64127 -217 1 5.62374 1.66322 7.51635 70.0554 58.4457 -44.6253 -218 2 5.02312 1.16941 7.9611 -67.4835 -53.4064 45.1295 -219 2 5.39821 1.60037 6.57846 0.425083 -1.20148 0.902483 -220 1 17.8844 1.0604 4.85627 -10.0966 -7.93422 8.12116 -221 2 18.57 1.49808 4.37578 15.6561 4.82809 -15.3219 -222 2 17.6975 1.64814 5.58583 -4.12013 1.11537 7.77052 -223 1 6.80576 9.4106 4.49942 14.9318 -4.14838 16.3077 -224 2 6.92469 9.61899 5.44741 -8.81338 -3.93454 -14.2946 -225 2 7.68422 9.10473 4.22333 -4.88591 1.73472 -0.668879 -226 1 2.61188 14.876 1.98504 -6.91902 -4.93882 19.1315 -227 2 3.25848 14.7083 2.68056 -2.68924 0.660774 0.84214 -228 2 3.12462 14.9058 1.19269 5.2127 1.18228 -19.2613 -229 1 17.303 12.9246 13.1525 10.3788 -12.5807 -3.95397 -230 2 16.4389 13.2985 13.3385 -0.36563 10.0164 -0.276732 -231 2 17.9169 13.6449 12.9311 -14.7092 -1.11942 1.9762 -232 1 14.9246 10.553 1.38722 24.8563 30.4026 18.8772 -233 2 15.5245 11.2788 1.76222 -27.4309 -28.2887 -15.3922 -234 2 14.0162 10.8271 1.54897 4.06804 -0.689498 -1.36825 -235 1 5.72717 6.70809 4.58418 -6.56467 23.581 -8.85087 -236 2 6.06385 7.62371 4.66236 -8.01259 -10.4186 -5.73866 -237 2 6.2767 6.1943 5.16785 8.48743 -6.29877 6.22452 -238 1 8.0009 8.33508 10.3687 14.1913 1.83663 -35.3126 -239 2 8.52082 9.13006 10.161 -0.0651459 -5.63876 7.89795 -240 2 7.94932 7.91253 9.48819 -6.75295 -2.00865 18.056 -241 1 13.4409 18.4268 5.72382 16.6357 0.722738 -15.7997 -242 2 12.6296 0.221713 5.47389 -5.04693 11.9449 -2.85301 -243 2 13.1936 17.8965 6.46343 -5.47963 -14.8645 21.1785 -244 1 0.0859293 2.63743 0.236192 -9.12202 -35.143 -2.56963 -245 2 17.9325 2.9505 -0.168165 -24.3821 -4.07692 -4.34214 -246 2 0.590564 3.4143 0.297916 33.333 32.0117 7.87133 -247 1 12.8395 11.0444 9.74231 45.1743 -31.9509 26.4779 -248 2 11.9686 11.0602 9.42407 -43.5447 -1.91263 -10.9888 -249 2 12.9558 10.1388 10.1456 -3.41612 23.6256 -14.6869 -250 1 0.710059 12.1592 11.0756 -10.531 -0.362272 -11.4251 -251 2 18.3753 12.1255 11.106 13.0957 4.94421 7.25875 -252 2 1.07349 12.4339 11.9177 -3.83141 1.58371 11.017 -253 1 5.10203 7.3136 13.4291 15.7719 5.5957 -0.396148 -254 2 5.6162 7.93373 12.8769 -6.75271 -3.40235 8.70115 -255 2 5.62723 7.25347 14.2483 -7.64248 -3.9813 -9.01905 -256 1 1.21129 6.85545 11.8946 29.9494 36.4661 12.0403 -257 2 0.485742 7.25442 11.415 -4.88796 -0.516932 -2.56673 -258 2 1.80546 7.64481 12.127 -26.2797 -36.2571 -7.59378 -259 1 15.5076 9.61367 12.3051 21.7085 -42.1446 -13.9552 -260 2 15.1772 10.4675 12.1584 -16.5272 42.565 -1.064 -261 2 15.3545 9.37182 13.2055 -3.21788 1.51701 18.7315 -262 1 16.6116 12.7513 5.5295 7.16384 -7.58562 22.1279 -263 2 16.3878 13.6701 5.61583 -3.61437 18.1746 3.54477 -264 2 16.4616 12.5615 4.61757 -3.38991 -5.42355 -25.0954 -265 1 6.3014 9.86096 0.0280098 12.3864 1.00447 14.78 -266 2 5.6246 10.4136 0.42972 -1.13337 -0.2267 2.50286 -267 2 7.03571 9.82087 0.686012 -15.2579 5.10695 -14.0237 -268 1 12.3034 6.12839 4.06739 18.1147 15.8957 -28.6536 -269 2 12.3348 6.66771 3.23063 -4.28261 -10.1618 29.3394 -270 2 11.5855 5.52112 3.9529 -14.8183 -8.35162 -1.01689 -271 1 0.289245 12.8118 0.17396 1.00074 4.7721 1.62068 -272 2 0.031574 13.4709 0.828681 0.933398 1.09562 1.96647 -273 2 18.4473 13.0492 18.0252 -3.3255 1.79332 -7.06642 -274 1 3.67377 18.6092 8.59256 -12.2718 12.3972 8.90671 -275 2 3.51633 18.2244 7.72678 0.0355868 -3.61867 -2.60117 -276 2 2.80982 0.36536 8.82196 13.0622 -5.69839 -0.636093 -277 1 7.44701 17.3263 4.47819 -12.2479 -42.1382 8.27198 -278 2 7.47198 18.2285 4.71954 7.46065 34.1282 3.2472 -279 2 7.59543 17.2523 3.54279 -0.328999 6.68987 -14.4609 -280 1 9.24493 17.1077 12.2387 -39.9724 15.9122 -7.56371 -281 2 9.27102 16.3677 11.6468 4.90539 -16.8252 -9.88175 -282 2 10.091 17.2207 12.6154 35.0883 -2.17581 15.9571 -283 1 13.2831 12.983 8.01599 31.7457 23.9761 -1.258 -284 2 13.3856 12.1913 8.53584 -3.88389 -9.78552 5.15809 -285 2 14.1414 13.4672 8.16531 -29.1617 -3.59582 -8.01118 -286 1 14.8948 2.98524 15.3712 -17.5751 0.764594 21.5491 -287 2 14.1876 2.34218 15.2724 -1.25262 -5.58382 2.64656 -288 2 15.4061 2.89645 14.5861 17.2961 2.13088 -20.5882 -289 1 9.89537 15.5662 16.9902 -4.09035 4.17693 9.89685 -290 2 10.2983 14.7234 16.7502 5.73332 1.10161 -2.59445 -291 2 9.67249 15.5035 17.9343 -2.60097 -1.56266 -9.87078 -292 1 11.3274 8.38795 16.5853 -21.4847 -13.5698 4.02619 -293 2 10.6433 7.93033 16.0536 12.1725 7.69909 5.41873 -294 2 11.2563 7.95351 17.4557 6.17465 6.37506 -11.4872 -295 1 3.9593 18.2162 16.7697 0.697619 -14.1615 -14.1273 -296 2 4.40283 17.477 17.2226 -3.01571 14.2153 3.03122 -297 2 3.77495 0.26362 17.3949 3.98021 5.349 11.1126 -298 1 2.22376 4.19593 8.92134 -23.2189 1.10906 -21.9008 -299 2 3.13693 4.25168 8.71451 27.6214 0.869066 -8.80864 -300 2 2.192 4.13003 9.85498 -3.77747 -6.53541 33.4183 -301 1 9.87956 10.3806 9.72418 15.1316 -34.7661 11.7533 -302 2 9.43202 11.1334 9.41625 -17.3542 37.4051 -17.5479 -303 2 10.0318 10.5223 10.6578 4.66737 -1.93825 10.7585 -304 1 9.70627 0.903434 10.8708 -16.6391 -17.8124 -8.64764 -305 2 9.32253 0.0380009 11.0933 9.22807 5.63208 7.52542 -306 2 9.08638 1.2149 10.1967 9.10725 8.78511 -0.274781 -307 1 9.19757 15.1031 10.2247 30.2853 16.2782 3.75492 -308 2 8.7691 15.7671 9.69642 -6.57671 14.9232 -6.79792 -309 2 8.58248 14.3993 10.2376 -24.9838 -23.9988 3.33467 -310 1 0.938497 9.56303 10.2766 -19.6808 1.12411 10.869 -311 2 0.864208 10.4264 10.69 -4.58503 2.29603 -0.877129 -312 2 1.8082 9.5891 9.92621 21.6362 -6.44505 -13.6115 -313 1 17.0002 4.85339 8.15215 21.2107 4.17599 -32.9154 -314 2 16.5226 5.60356 8.44909 -16.9553 23.1583 5.35412 -315 2 16.856 4.21761 8.81327 -1.81027 -27.4365 28.1652 -316 1 14.7301 14.7112 0.178334 14.6842 0.804622 -15.2869 -317 2 15.1474 15.2511 0.844024 6.42123 6.45952 11.8737 -318 2 13.9865 14.3021 0.591484 -20.7841 -7.92944 9.37323 -319 1 3.69091 11.0487 9.53568 5.98335 -8.96355 13.8332 -320 2 3.56651 11.2839 10.4631 4.16949 4.48414 3.3219 -321 2 3.23005 11.7193 9.04032 -8.2098 7.45463 -11.8198 -322 1 11.2005 10.7579 1.45634 -8.62161 -19.8695 4.90197 -323 2 11.5404 11.5862 1.17391 12.694 26.4047 -12.3165 -324 2 10.2904 10.7467 1.15081 -4.44873 -2.97897 0.910453 -325 1 13.1494 7.14877 12.735 25.4211 -2.46103 0.847156 -326 2 14.1287 7.02261 12.7655 -19.3043 2.68773 1.11168 -327 2 12.7806 6.27183 12.8763 -3.1166 -1.04351 -1.25783 -328 1 9.62343 1.89491 0.979311 -12.9604 6.63616 -29.4885 -329 2 8.7946 1.64267 0.49669 19.6199 4.62861 14.6045 -330 2 10.1494 2.42868 0.345455 -5.12075 -11.8177 11.3147 -331 1 10.6335 13.514 4.5646 -17.0056 -0.486025 -1.57099 -332 2 11.3585 12.913 4.68456 17.6411 -7.84828 -0.965736 -333 2 10.6299 14.042 5.36013 -0.769181 5.74096 10.189 -334 1 14.4133 1.73933 10.9414 -11.8391 -17.207 6.29742 -335 2 15.2077 1.35218 10.5638 5.14778 2.73806 -3.87278 -336 2 14.5015 2.69292 10.9149 5.22965 5.71868 -2.86675 -337 1 14.5722 12.1975 11.686 14.094 -1.05888 37.2495 -338 2 15.3017 12.3928 11.129 31.2021 7.92611 -10.369 -339 2 13.8916 12.0994 11.0714 -43.9062 -9.54665 -27.6985 -340 1 8.20779 5.06885 9.81189 17.2837 -27.279 -13.9945 -341 2 7.476 5.2926 10.3565 -21.7486 9.79802 13.7153 -342 2 8.11585 4.0945 9.69767 5.61634 21.6585 -4.44102 -343 1 1.51211 16.8659 18.4077 -7.21278 -21.5738 6.32543 -344 2 1.92778 17.2486 17.641 3.99023 3.9685 -12.2343 -345 2 1.4425 15.9033 18.1995 7.9863 23.2313 7.90302 -346 1 1.50475 17.27 15.3217 -52.6385 22.4638 18.049 -347 2 1.49283 18.1952 15.6793 7.67726 -26.1665 -10.1971 -348 2 0.544177 16.9836 15.4083 37.5739 4.67989 -9.3974 -349 1 3.64958 5.72975 6.08508 6.29069 -26.5723 -11.3796 -350 2 3.20343 6.25343 6.73323 -12.457 15.9806 12.721 -351 2 4.14586 6.29176 5.4852 3.70859 6.95385 1.18178 -352 1 12.4272 9.46789 14.1967 -22.2867 60.9428 4.59069 -353 2 12.8141 8.72569 13.8244 25.5413 -52.6107 -24.0302 -354 2 12.2248 9.22264 15.0865 -2.36671 -8.29514 20.866 -355 1 4.05215 15.2773 6.93811 -37.3363 -16.6714 15.1212 -356 2 3.52112 16.0418 6.69595 1.88806 4.21981 -3.16255 -357 2 4.93922 15.5036 6.7631 37.0693 10.9568 -7.31607 -358 1 0.634621 8.6113 14.9988 -1.00168 -8.57623 6.03626 -359 2 0.426563 9.53409 15.1284 -0.450123 11.8509 1.14186 -360 2 1.36493 8.60238 14.3834 7.02364 0.17651 -8.78598 -361 1 12.9488 8.28918 10.2591 -12.3232 2.05195 12.3522 -362 2 13.6164 7.77926 9.80228 8.67745 -2.84232 -3.45719 -363 2 12.9296 7.914 11.161 -0.920073 6.75149 -12.343 -364 1 15.3287 7.72887 3.53701 30.7324 40.0945 -27.1654 -365 2 14.5687 7.40616 3.08394 -23.025 -16.3354 4.19175 -366 2 15.5452 7.39964 4.39595 -10.5646 -17.2283 18.769 -367 1 17.3078 6.69366 0.0430756 19.9915 -9.88107 5.38445 -368 2 16.7705 5.94464 0.294276 -4.0765 -7.9871 3.32428 -369 2 16.6874 7.33606 18.3865 -21.7939 19.8828 -6.94939 -370 1 8.91017 6.93043 7.77699 23.4025 28.7729 -7.70378 -371 2 9.81824 7.33337 7.84479 -23.824 -15.1706 -1.9244 -372 2 8.86104 6.22236 8.40836 -0.772968 -13.4081 16.1446 -373 1 12.3843 0.611213 1.25908 1.98263 -0.697807 -4.79042 -374 2 13.323 0.393307 1.31761 -0.925839 8.32556 5.35041 -375 2 12.1237 0.465738 0.350227 -1.33982 -4.5367 -2.71568 -376 1 5.61465 15.1448 14.5392 -1.26631 -30.1046 6.25467 -377 2 4.66418 15.2406 14.6702 -0.2102 4.52428 0.84195 -378 2 5.97383 15.921 14.1393 5.11494 24.4221 -7.05072 -379 1 3.84895 6.44034 1.72963 2.7696 -8.11358 7.79979 -380 2 3.51864 7.3032 1.48291 -7.06055 11.1725 -5.60147 -381 2 3.99368 6.51729 2.68239 -0.0521329 1.22822 -5.4234 -382 1 3.90083 11.5778 12.3664 -12.9911 -8.32668 -3.5509 -383 2 4.78352 11.9371 12.4749 4.25232 1.56379 3.39016 -384 2 3.29545 12.1182 12.8978 7.28302 -2.19426 -6.07273 -385 1 5.34262 3.87885 15.873 -6.15348 -82.0204 -11.7996 -386 2 6.0076 3.23261 15.5032 -15.8888 19.1459 15.4213 -387 2 5.69117 4.71679 15.7838 27.5644 60.3601 -6.10452 -388 1 14.3156 10.2471 4.51115 -35.9806 40.7967 42.7391 -389 2 14.5125 9.92103 5.39777 -3.50802 -2.54983 -0.445713 -390 2 14.828 9.75135 3.94137 33.3968 -38.7315 -40.7643 -391 1 7.75287 17.3919 9.13705 13.5919 -13.2315 -4.02741 -392 2 6.89819 17.6363 9.44363 -21.9658 0.853712 16.3055 -393 2 7.88604 17.9611 8.38483 9.7933 6.77297 -11.9047 -394 1 4.50916 14.5069 3.91348 -1.14645 -26.1805 -53.139 -395 2 4.48781 15.3883 4.18695 -0.715057 47.311 12.47 -396 2 4.59583 14.0061 4.68593 4.03467 -28.7439 39.2156 -397 1 14.2649 7.40032 15.8248 -22.801 -12.9293 -21.4811 -398 2 15.1988 7.32934 15.7188 25.9215 -1.64325 -3.33443 -399 2 14.1282 7.83404 16.6492 -0.714938 9.98648 22.5393 -400 1 3.02257 18.338 1.93829 -9.63799 -32.7056 -36.1055 -401 2 2.55646 17.7535 1.2554 15.187 19.9859 31.9951 -402 2 2.37728 0.279403 2.32429 -11.6166 9.08866 3.80637 -403 1 7.9856 1.63208 4.58686 -21.2194 7.37107 -10.8429 -404 2 7.46714 2.08087 3.89599 -2.9365 -3.17783 11.7342 -405 2 8.82293 1.5175 4.16848 19.7493 -4.53145 -2.81354 -406 1 2.46603 14.1528 17.6814 26.4379 24.7021 -16.3984 -407 2 1.84119 13.6421 18.1459 -27.3849 -25.1212 16.5566 -408 2 3.3203 13.7773 17.9154 6.17156 -2.74614 2.81365 -409 1 0.847673 1.77812 13.8995 -29.1857 4.71799 7.40329 -410 2 0.70153 1.57851 14.8469 9.71331 1.1605 -15.3576 -411 2 18.5888 1.96886 13.5517 20.2657 -3.94578 7.10705 -412 1 4.44078 18.6823 13.9019 -16.0244 4.84661 7.61196 -413 2 5.30649 18.3093 13.8135 20.8517 -5.19628 -2.25594 -414 2 4.21344 18.5423 14.8331 -2.2181 0.553195 -4.50589 -415 1 7.17333 0.707602 18.3659 18.5924 -14.7376 -19.2949 -416 2 7.29313 0.222373 17.5065 -5.17699 16.3575 23.4569 -417 2 6.28409 1.05221 18.4099 -11.4153 -0.902781 0.0516699 -418 1 16.0458 18.3995 13.9929 19.922 2.02833 15.0786 -419 2 15.1358 18.307 13.8248 -34.099 -5.52537 -15.9309 -420 2 16.0494 18.5146 14.948 8.19193 5.7614 4.60276 -421 1 10.1078 4.56818 16.2539 38.806 25.935 -8.65561 -422 2 11.0636 4.83663 16.0361 -35.078 -16.4147 14.4025 -423 2 10.0818 3.61692 16.3176 2.43484 -11.3153 -3.34335 -424 1 15.9163 17.7591 4.46968 32.0074 -29.6155 -15.1132 -425 2 16.5099 -0.143617 4.50341 7.95185 14.4383 0.237761 -426 2 15.1003 18.0575 4.79025 -43.3278 16.7712 13.4837 -427 1 7.00774 17.4246 13.8321 -56.0949 -7.97771 -22.4327 -428 2 7.49162 17.6994 14.5684 25.5375 13.311 41.1471 -429 2 7.64463 17.2266 13.1734 23.6351 -3.93018 -21.4132 -430 1 13.2756 6.47326 6.61789 23.4956 20.1255 -14.8261 -431 2 14.0898 6.99784 6.40679 -18.3755 -16.6425 15.9473 -432 2 12.9103 6.33261 5.73881 -7.54238 -3.20295 2.17295 -433 1 7.79764 2.32743 9.30513 0.620653 -0.611916 41.3127 -434 2 7.26457 2.16571 10.1169 11.5422 6.28076 -11.6799 -435 2 7.22158 2.07024 8.60986 -14.5852 -6.72752 -26.4814 -436 1 15.1722 14.8472 13.687 6.75051 -12.1688 -2.41191 -437 2 14.9232 15.197 14.5358 -2.94711 1.82763 14.9216 -438 2 14.8185 15.4404 13.0388 -8.36185 8.62669 -11.0165 -439 1 9.38377 8.31795 3.7734 -21.5197 15.3047 -10.1967 -440 2 10.1883 8.66352 4.14356 14.5642 4.86611 3.27566 -441 2 9.4002 7.3753 3.8765 5.94621 -16.0238 5.03493 -442 1 17.77 13.5913 16.4331 -7.58631 -31.5789 18.0626 -443 2 16.8485 13.2919 16.3991 0.887673 4.05725 -0.920823 -444 2 17.783 14.4232 15.9937 -0.095827 22.773 -14.6224 -445 1 4.93053 10.5741 2.80353 -17.5831 18.6377 -10.1976 -446 2 5.6584 10.2884 3.33403 15.5926 -12.1878 10.3648 -447 2 4.56303 11.3186 3.30761 3.36544 -9.45409 -4.10473 -448 1 3.72361 8.36764 10.1215 3.29328 14.9495 -8.98506 -449 2 3.89363 9.29817 9.8724 -2.16289 -13.6958 -0.787578 -450 2 3.61222 8.39575 11.0685 -3.0862 -1.08413 10.2171 -451 1 15.9739 6.97387 6.06952 -13.2047 20.7109 0.201327 -452 2 16.7663 7.43242 6.33309 11.9845 5.69104 3.28059 -453 2 16.2425 6.10629 5.81378 6.71976 -25.6546 -0.898294 -454 1 15.1226 7.10933 9.08497 -8.54326 -39.6564 44.8588 -455 2 15.7377 7.52152 9.6861 12.0306 8.12876 4.18876 -456 2 15.1451 7.58697 8.30383 2.04885 32.3579 -51.8464 -457 1 6.29947 12.9646 12.7695 3.37722 -4.66482 -6.66232 -458 2 7.17165 12.6249 12.9809 1.24175 -10.0492 1.61343 -459 2 6.12977 13.6114 13.4445 -6.34808 15.4581 9.54933 -460 1 12.1164 4.51054 13.0962 -37.6646 -34.1548 1.17408 -461 2 12.2607 4.59773 14.0409 7.03003 6.16295 4.50476 -462 2 11.318 3.89029 13.036 30.5495 29.2935 -6.64922 -463 1 11.3767 8.15056 7.89733 -18.501 8.72492 -14.0328 -464 2 11.9999 7.57003 7.45959 11.3303 -6.40222 -0.944592 -465 2 11.6722 8.28384 8.79215 9.56916 -2.23029 14.0742 -466 1 17.1624 10.8628 7.5038 -34.939 16.2827 29.0255 -467 2 17.7665 10.1757 7.31962 29.6392 -23.074 -13.6235 -468 2 17.1223 11.4937 6.79065 1.17945 1.22203 -15.4432 -469 1 5.28569 18.1322 10.989 31.979 0.201705 -2.44437 -470 2 4.81806 17.865 11.7612 -14.4656 -7.34411 17.8618 -471 2 4.63582 18.2948 10.3295 -20.6991 2.34913 -21.9288 -472 1 7.59755 17.5197 1.78957 -4.56355 -5.70379 -23.6831 -473 2 7.90081 16.7255 1.29504 -6.23989 15.492 10.1621 -474 2 7.18064 18.108 1.12072 15.1074 -6.58967 11.1205 -475 1 1.93009 12.8809 13.5782 -3.15102 -7.76664 -18.9393 -476 2 1.45787 12.3423 14.2065 -6.90584 -5.9659 9.51664 -477 2 2.19823 13.666 14.0335 5.43227 17.0545 14.7464 -478 1 9.58089 6.76558 14.8178 3.72821 -35.8509 -10.9213 -479 2 9.75861 5.80832 15.0417 -6.66727 32.4051 0.0155959 -480 2 9.77461 6.83059 13.8656 0.408011 6.2359 8.07479 -481 1 15.2957 4.27102 10.7659 9.27088 14.9202 31.1326 -482 2 16.1322 3.95288 11.1528 -7.49935 1.06904 -21.0932 -483 2 15.0846 4.9939 11.387 -3.9034 -8.13187 -14.3813 -484 1 11.2455 6.18064 0.162868 26.0255 26.7031 14.5737 -485 2 11.4763 5.37121 18.3763 -4.81733 -21.4086 -8.3593 -486 2 10.308 6.3098 0.211594 -20.2553 -5.22819 -8.60243 -487 1 0.00824002 11.3791 15.0352 26.3856 -8.14992 32.1511 -488 2 18.096 11.5216 14.3022 -25.0888 8.62779 -34.0528 -489 2 -0.201285 12.127 15.606 2.8625 2.75044 1.90901 -490 1 7.02689 9.25213 7.27678 19.2929 16.5016 -4.78745 -491 2 6.59278 8.51389 7.67295 -14.5933 -20.8184 8.5158 -492 2 7.9603 9.00351 7.26624 -3.73747 1.30273 -1.02295 -493 1 18.3276 15.3446 12.3362 -3.78489 -4.33158 3.75643 -494 2 0.608087 15.5074 12.1532 11.0792 5.95639 -3.98767 -495 2 17.812 15.8736 11.72 0.968766 1.6464 -4.64437 -496 1 16.5183 4.40219 5.2766 -9.25512 24.5768 -59.2644 -497 2 16.7942 3.98653 6.05327 18.9035 -16.7679 44.3388 -498 2 17.2936 4.55111 4.6869 -10.7937 -7.24122 14.527 -499 1 17.7074 3.16435 10.7411 -7.07567 -19.8863 -1.17515 -500 2 18.5775 3.40914 11.0222 18.8337 10.6004 6.41913 -501 2 17.8312 2.27039 10.3862 -7.09349 4.4518 -2.20884 -502 1 12.3002 -0.0151335 10.1074 11.0606 -47.8945 -14.4391 -503 2 11.4203 0.251866 10.2671 -34.8312 14.3717 9.25421 -504 2 12.8296 0.729107 10.2725 26.3435 36.9272 6.71278 -505 1 10.377 9.78 12.4264 -19.0889 -11.9366 -11.7107 -506 2 11.0349 9.79085 13.1125 14.2042 0.527855 9.4859 -507 2 10.1856 8.83311 12.286 4.63513 11.4958 0.11243 -508 1 0.612468 2.80552 7.03105 -3.16196 -18.6605 -12.6623 -509 2 0.888173 3.44011 7.68312 3.89236 7.11247 14.3448 -510 2 0.935234 1.94488 7.34043 -2.08916 10.0979 2.30791 -511 1 0.333274 15.3197 6.88029 -14.1577 45.9776 55.0939 -512 2 0.45846 14.8119 7.69617 1.50982 5.91417 -3.14315 -513 2 0.483825 14.7581 6.18064 16.8578 -51.3136 -47.9608 -514 1 17.0479 7.0004 15.1603 7.32733 3.15391 4.0553 -515 2 17.7743 7.62519 15.0492 -4.65368 3.90748 -3.79045 -516 2 17.4843 6.26113 15.5911 -6.30626 -9.6282 -1.63315 -517 1 9.09335 12.4409 8.06571 39.5186 -12.5139 -7.54936 -518 2 9.34597 11.7249 7.45783 10.9221 9.9246 5.15013 -519 2 8.17581 12.4072 7.99758 -53.4732 7.6014 3.58329 -520 1 1.26136 1.81045 2.95361 -2.6705 2.40839 8.80735 -521 2 0.548126 2.01955 2.35817 -5.69651 1.92544 -13.4687 -522 2 1.50342 2.66138 3.33407 8.35517 -3.762 3.05283 -523 1 4.10861 15.1005 9.87028 17.6559 -3.6711 -5.25272 -524 2 3.99986 15.4157 8.96812 -4.49733 0.314881 -1.79245 -525 2 5.04559 14.8362 9.90181 -11.0653 1.71965 6.05025 -526 1 7.3044 2.18074 14.6544 -4.4599 -5.38687 1.90914 -527 2 7.13921 1.65822 13.8561 -1.41133 5.62984 3.30149 -528 2 7.58548 3.05039 14.3636 5.58134 3.87352 -5.39735 -529 1 18.5311 14.6245 2.16796 -28.4168 7.73599 -0.688338 -530 2 0.75601 15.0339 2.21782 2.27339 5.70314 -0.294719 -531 2 17.8249 15.3246 2.17516 22.0369 -13.9852 -0.651534 -532 1 9.98569 2.74939 12.8982 -9.19221 10.3282 12.793 -533 2 9.83979 2.05829 12.2602 3.07064 -9.86428 -11.8695 -534 2 9.16543 3.26718 12.8794 9.24196 0.527571 1.01071 -535 1 2.93657 8.90297 13.0427 17.8365 13.1008 0.527628 -536 2 3.20967 9.8454 12.9227 -4.18066 -20.4527 0.554358 -537 2 3.74278 8.43516 13.3493 -16.2822 5.83343 -3.94486 -538 1 3.21464 8.50963 3.72772 0.0178718 14.8284 -74.1155 -539 2 3.59865 9.33251 3.32895 -6.0017 -25.5341 4.84747 -540 2 3.33657 8.62148 4.62381 5.38554 5.83243 67.2306 -541 1 5.61344 7.20035 8.58446 -2.8239 -8.19112 0.0562215 -542 2 5.53456 6.24006 8.54079 8.61958 1.67382 -4.34837 -543 2 5.04066 7.41711 9.32304 -1.21443 9.5719 0.536432 -544 1 14.8964 1.44105 1.93253 -7.61412 -10.5809 19.4064 -545 2 14.4541 2.19461 2.37874 12.2686 -5.42452 -16.4906 -546 2 15.2548 1.628 1.06483 0.86569 15.045 -4.43663 -547 1 8.4154 15.1546 0.810786 1.70028 1.58395 -11.225 -548 2 9.17382 15.0707 1.40016 -1.99176 -3.13146 6.02583 -549 2 7.70673 14.5929 1.15135 2.54266 -0.476233 4.63029 -550 1 15.567 1.36482 7.20444 28.1778 15.3746 16.2283 -551 2 15.0185 0.765154 6.74682 -23.3742 -21.8939 -17.7163 -552 2 14.9729 1.99808 7.60632 -6.19001 12.1291 -0.330309 -553 1 5.0089 13.0207 18.4853 -18.4609 -5.74542 -15.9738 -554 2 5.42479 13.0864 0.690362 9.95106 2.52519 17.0862 -555 2 5.65544 13.3331 17.8473 1.85993 1.51979 0.712767 -556 1 15.3671 8.54929 18.1095 -8.15636 -15.968 22.0227 -557 2 15.6817 9.03573 17.3686 11.3034 18.5085 -22.2724 -558 2 15.31 9.18561 0.190372 -2.38163 -0.236806 -1.34825 -559 1 12.0802 3.07221 18.3457 4.60183 -13.894 -6.42275 -560 2 12.4859 2.4 0.260392 -4.96838 8.65649 13.1594 -561 2 12.2775 2.7013 17.4791 -3.58827 6.63097 -2.22236 -562 1 13.1993 12.6855 5.15579 5.61247 -4.39703 15.9491 -563 2 13.8115 11.9693 4.94018 -5.07495 0.365899 -6.13845 -564 2 13.2564 12.743 6.12308 -1.32671 2.90452 -5.88021 -565 1 6.08204 7.19061 0.120725 -6.90673 14.7019 -8.65455 -566 2 5.87336 8.13986 -0.0835188 5.89552 -25.7895 13.7146 -567 2 5.2676 6.79179 0.465292 5.04542 5.75855 -0.526985 -568 1 17.7014 15.9063 14.9696 22.6091 -4.25312 7.62853 -569 2 16.8618 16.3646 15.0156 -4.32677 -2.50983 -14.3551 -570 2 17.9392 15.6583 14.0532 -15.4152 10.9643 9.19951 -571 1 13.1673 0.955706 16.6058 -16.4624 13.9879 0.0318296 -572 2 14.0199 0.765403 16.9805 16.2653 -3.85138 1.37902 -573 2 12.7278 0.106773 16.5459 -0.203322 -8.12911 -4.60325 -574 1 10.9967 14.5844 7.33958 -18.0316 -21.646 7.99268 -575 2 10.1705 14.1548 7.70673 29.6081 10.2394 -10.7243 -576 2 11.7328 13.9554 7.47718 -10.5059 7.23567 0.829732 -577 1 17.5629 8.52802 2.09087 -9.01192 -26.3923 -8.78708 -578 2 16.6633 8.41226 2.4486 12.6056 4.50253 0.467713 -579 2 17.6588 7.73531 1.50133 0.834193 24.7006 12.2923 -580 1 12.3809 7.87992 1.9744 6.05515 -15.9846 -5.53898 -581 2 11.7749 8.59773 2.10936 -4.35558 14.0343 4.46215 -582 2 11.9629 7.32605 1.30246 4.89043 0.565697 0.45699 -583 1 11.9793 14.6347 10.4335 18.2405 9.923 28.253 -584 2 12.2756 14.1199 9.71871 15.2703 -21.0335 -29.0838 -585 2 11.0615 14.7405 10.2767 -32.5541 7.66631 -1.56623 -586 1 6.81522 6.956 15.5295 -17.6641 -14.7432 -7.98444 -587 2 7.71149 6.86909 15.2553 24.3623 -4.30517 -12.3513 -588 2 6.87971 7.6292 16.1782 -5.40685 18.4787 21.7047 -589 1 8.03389 4.5887 13.4155 -37.171 -3.64226 -22.5123 -590 2 7.25568 4.78495 12.82 23.9185 -7.87368 18.6792 -591 2 8.43341 5.43391 13.5743 6.319 9.72574 1.79505 -592 1 13.4002 12.1853 14.3374 -4.54681 1.91445 -1.84351 -593 2 13.053 11.3082 14.1695 -1.05297 -9.08012 2.89826 -594 2 13.8525 12.4201 13.5231 2.34057 5.70396 -2.70792 -595 1 14.6576 9.49709 7.25838 9.71531 18.8932 28.1379 -596 2 15.5128 9.94191 7.46983 -15.999 -8.53149 -8.43731 -597 2 14.0596 9.76702 7.98865 8.11873 -7.0154 -18.3951 -598 1 12.7312 16.9238 3.19475 21.2814 -46.1617 -18.4213 -599 2 12.8913 17.1254 4.09275 6.71284 11.8391 31.6773 -600 2 12.0991 17.5238 2.88672 -32.0955 36.7838 -15.6883 -601 1 1.05963 7.10571 17.4007 12.4792 -13.0695 22.2141 -602 2 0.186546 7.34268 17.7101 -8.13154 -6.52047 1.59159 -603 2 1.15324 7.46505 16.5336 -1.37945 14.6986 -20.6467 -604 1 12.8789 5.0234 15.6828 -31.729 4.63914 -0.239626 -605 2 13.551 4.37036 15.6981 25.2388 -22.1242 0.0408259 -606 2 13.353 5.8465 15.7229 6.14669 17.5754 0.411177 -607 1 2.40704 3.36861 5.12193 5.52974 -41.8871 -53.5671 -608 2 1.82145 3.26591 5.8288 -30.6852 -8.64892 41.0269 -609 2 2.78115 4.20498 5.20734 26.4804 50.2953 11.9131 -610 1 8.27515 11.124 13.5771 -2.85187 11.2881 -70.0801 -611 2 8.37295 10.8581 14.431 -1.92558 -15.2628 85.0569 -612 2 8.99363 10.6344 13.1748 6.72692 3.2721 -14.9 -613 1 12.918 1.48119 13.2724 -5.46048 -28.9446 23.2516 -614 2 13.637 1.39783 12.6661 14.6279 -0.945194 -20.1211 -615 2 12.6406 2.36931 13.1901 -10.8983 31.3672 -5.19186 -616 1 6.50945 13.6334 2.15016 9.54562 -3.73103 -23.7728 -617 2 5.85792 13.9589 2.75542 -11.9505 6.96003 17.098 -618 2 7.07728 13.0286 2.63475 0.813075 1.46302 3.43305 -619 1 15.9192 6.52891 12.704 16.1802 17.7634 -8.70325 -620 2 16.3422 7.10874 12.0232 -9.40583 -17.3352 17.4966 -621 2 16.4304 6.67694 13.5293 -11.6709 -4.5663 -12.9766 -622 1 16.8012 0.7168 9.58424 5.37965 28.6432 5.104 -623 2 16.9134 18.4317 9.69441 -4.13374 -28.9785 4.85106 -624 2 16.4797 0.860059 8.69243 -6.31121 -1.15561 -8.50241 -625 1 6.13999 11.6637 8.32406 3.84263 60.0529 3.8669 -626 2 5.34748 11.493 8.80779 -22.31 -6.18549 9.45125 -627 2 6.46273 10.8378 8.08078 19.7827 -51.2376 -16.1138 -628 1 2.82548 8.7059 0.356008 25.1404 7.14145 17.7175 -629 2 2.1872 8.20684 18.5458 -21.47 -27.2684 -27.7438 -630 2 2.28201 9.37487 0.754925 -1.41085 15.0233 10.6798 -631 1 10.1039 10.4509 6.57992 -4.79526 -6.25674 7.70278 -632 2 10.5083 9.74309 7.09516 2.94215 -0.723708 0.948173 -633 2 10.6276 10.5201 5.78606 4.97834 -0.717699 -12.6856 -634 1 6.77313 15.7547 6.63388 -5.578 -17.4503 -5.92282 -635 2 7.15743 16.0375 7.46176 7.11582 8.10879 3.23091 -636 2 7.28529 16.1142 5.89948 -1.84538 11.4125 4.1387 -637 1 6.44197 13.0281 5.69829 11.2984 8.90971 -1.05733 -638 2 6.79679 13.8886 5.97631 -5.91305 -5.55439 0.155281 -639 2 6.12445 12.6032 6.49753 -3.74834 -3.51916 3.00547 -640 1 16.7803 12.5246 9.7433 1.48678 16.9805 10.4147 -641 2 16.9869 12.0132 8.97443 1.49858 -19.0548 -12.8116 -642 2 17.3026 13.3224 9.61445 -4.02823 0.499055 5.20393 -643 1 6.14077 2.94238 2.79674 5.90568 12.9134 -1.15866 -644 2 6.37771 3.87334 2.54509 -6.86675 -27.0997 0.367621 -645 2 5.77601 2.45475 2.03942 1.6023 9.98348 0.439644 -646 1 10.8329 3.18005 3.24633 -5.48645 -3.34604 -3.46544 -647 2 10.1887 3.87164 3.40992 -1.49044 3.74393 4.82403 -648 2 10.5052 2.73309 2.45537 3.4248 -0.0323397 2.60803 -ITEM: TIMESTEP -60 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.78901 6.89398 17.9776 -3.5234 1.93788 3.89787 -2 2 7.91305 7.05712 18.3419 -1.4277 0.241332 2.63834 -3 2 8.67661 6.15674 17.3832 1.3639 -6.15529 -7.04239 -4 1 18.7561 8.31771 6.77309 10.5748 -7.50476 -33.4266 -5 2 0.457617 7.9886 5.89382 -17.7288 16.9324 23.762 -6 2 0.568724 7.76979 7.40723 1.86737 -7.24646 12.6232 -7 1 8.51532 18.7703 6.84705 0.662358 -5.68449 9.56329 -8 2 9.4329 0.211311 6.58737 4.53489 1.21926 -2.36791 -9 2 8.05203 0.803554 6.35578 -1.87482 6.91549 -4.54998 -10 1 6.50103 1.76445 11.707 -23.9337 -6.76257 7.94266 -11 2 5.68898 2.17855 12.0897 23.4576 -7.00878 -10.5629 -12 2 6.21872 0.874053 11.3985 3.54415 20.4784 6.13886 -13 1 7.00577 5.62696 2.40487 20.8008 -18.6778 -13.9491 -14 2 6.3381 5.93149 2.99593 -12.7158 11.2498 18.9927 -15 2 6.96044 6.19487 1.63998 -3.33571 5.44078 -9.1088 -16 1 16.2317 10.2379 16.0906 -2.65398 7.02849 4.45196 -17 2 17.1094 10.623 16.0697 3.52116 -7.47169 -6.62031 -18 2 15.6835 10.996 16.3292 -1.12895 -7.31017 -0.603728 -19 1 10.664 14.9341 2.30567 13.0251 3.56406 6.3158 -20 2 10.7336 14.2976 3.03428 -5.34804 6.23285 -3.50086 -21 2 11.2229 15.6743 2.58509 -4.07292 -1.48419 -0.585019 -22 1 17.1728 8.23947 10.7128 -1.64499 -1.99855 0.608593 -23 2 16.6728 8.84067 11.2819 0.316783 0.889357 -0.63917 -24 2 17.9322 8.74349 10.3965 1.71935 0.329185 -1.07247 -25 1 14.697 15.9473 16.4368 -13.7705 -0.197196 -7.11694 -26 2 13.7879 16.279 16.3001 13.6207 -4.8592 3.02749 -27 2 14.6438 15.4158 17.2461 5.07545 7.5417 -4.99128 -28 1 12.1134 13.367 0.528093 -6.39608 9.01831 -4.72995 -29 2 11.8173 13.4954 18.2644 6.74141 -8.66363 -5.87361 -30 2 11.5587 13.987 1.01769 3.38254 -3.71164 8.60635 -31 1 9.30318 5.47999 3.94883 35.8178 1.45581 -2.5285 -32 2 8.76671 5.2044 4.67379 -16.9173 -4.15595 18.9992 -33 2 8.71572 5.58687 3.21666 -20.2172 1.55363 -14.8227 -34 1 1.70529 4.08306 11.601 -3.00308 -9.11056 -2.97947 -35 2 1.52513 4.97184 11.9147 2.37337 9.05749 0.600173 -36 2 2.22567 3.63839 12.2786 -1.82607 -0.283286 1.9059 -37 1 2.04499 6.82744 8.26893 9.18028 14.0429 7.96475 -38 2 2.5896 7.29904 8.93262 -11.3816 -6.25496 -6.31442 -39 2 1.81536 5.98181 8.67357 4.33854 0.450625 -3.71013 -40 1 5.3656 4.4774 7.93824 1.44041 9.72132 7.59831 -41 2 5.44269 3.52851 7.84762 -1.19648 -12.0175 -6.62376 -42 2 4.92598 4.83778 7.16432 -9.0894 -3.97332 -7.9273 -43 1 3.32251 2.9413 17.4443 0.538374 -34.3486 -6.77872 -44 2 3.98642 3.24962 16.8336 8.9197 7.73227 -3.39959 -45 2 3.04976 3.68399 17.9526 -12.2781 23.4468 13.5982 -46 1 7.437 5.38423 6.13063 5.01567 -0.272219 -26.6536 -47 2 7.97737 5.94965 6.66546 10.8347 10.076 12.8667 -48 2 6.99068 4.78917 6.71033 -9.3836 -11.0864 17.8628 -49 1 9.80479 7.01238 12.0379 -9.46641 4.39554 -21.4508 -50 2 10.3276 6.40912 11.4906 -4.30802 3.34771 7.14548 -51 2 9.13044 7.38666 11.4225 10.4612 -8.54147 15.485 -52 1 14.0024 3.65677 8.07153 1.90613 10.1899 13.6881 -53 2 13.9361 4.48059 7.56554 -1.4656 -7.0627 2.39316 -54 2 14.1946 3.93561 8.9889 0.417494 -3.38136 -15.0381 -55 1 4.51888 17.1453 3.95588 7.87944 -4.67708 3.20643 -56 2 5.41436 17.4585 3.90856 16.3959 1.38908 8.05638 -57 2 4.13204 17.4705 3.15493 -16.1768 7.51082 -11.5461 -58 1 16.4506 16.6012 10.3314 -28.9812 -6.12917 4.01051 -59 2 15.5905 16.5574 10.8183 20.4446 2.48532 -11.9951 -60 2 16.2667 16.1387 9.49338 0.364513 2.67256 9.91326 -61 1 1.97065 4.79938 0.260671 -8.10245 -17.5737 -13.0373 -62 2 2.41281 5.12274 1.03667 10.218 10.6244 9.40508 -63 2 1.8267 5.54768 -0.321227 -3.59337 9.6389 -0.147197 -64 1 11.5035 13.2586 16.3577 -0.713967 20.2415 12.8794 -65 2 11.0441 12.4305 16.4814 -6.19498 -9.28579 -2.23027 -66 2 12.0754 13.1484 15.6021 5.65191 -4.41955 -9.63321 -67 1 10.1276 11.0105 16.8449 -6.46201 16.5427 1.83518 -68 2 10.5556 10.1721 16.794 12.0656 -22.7421 -1.13044 -69 2 9.20289 10.8171 16.6996 -9.212 1.56961 -0.130134 -70 1 11.787 17.4505 13.4822 -3.74088 11.88 -4.97071 -71 2 12.2373 16.9277 12.8063 6.56705 3.4706 4.72845 -72 2 12.0251 18.3805 13.3063 -1.30808 -7.68873 2.97322 -73 1 6.42132 9.37259 12.2366 13.1698 8.24141 3.19081 -74 2 6.99069 9.01867 11.5406 -12.3498 -0.982732 4.41902 -75 2 7.03807 9.88277 12.7853 -8.70879 -2.27031 0.0855326 -76 1 16.2815 12.8722 2.70224 -2.02351 7.50879 0.830271 -77 2 17.1172 13.3658 2.56775 -16.1548 -5.18742 1.80773 -78 2 15.5334 13.5108 2.69253 18.3367 -6.33955 1.64103 -79 1 0.729913 12.6587 5.89268 5.90957 5.27776 3.54404 -80 2 1.01336 12.4973 4.99287 4.32656 -0.558571 -7.43154 -81 2 18.4322 12.7877 5.81211 -15.2269 -3.44557 0.704235 -82 1 5.2582 16.4249 18.4194 -10.384 10.1199 -1.35479 -83 2 5.6864 15.6785 18.0038 6.48963 -9.24773 3.62069 -84 2 5.52942 16.4885 0.694307 6.00107 -3.50652 -0.438993 -85 1 0.618748 7.72132 4.16911 -57.0293 -28.7954 36.7096 -86 2 18.6577 8.06272 3.52122 -10.6934 7.30065 -13.2418 -87 2 1.44908 7.88182 3.83946 68.942 18.8036 -26.9673 -88 1 3.13476 8.97804 6.4725 9.50813 11.9402 -13.0637 -89 2 3.74054 8.49646 7.01761 11.8689 -6.06991 10.2621 -90 2 2.28514 8.86225 6.86989 -19.244 -2.30506 4.89646 -91 1 7.29998 10.3842 16.2581 17.8205 -0.109318 -17.8263 -92 2 6.62843 10.5749 15.608 -5.58859 2.04705 -1.34953 -93 2 6.87201 10.3756 17.1052 -6.43011 -2.48695 12.6131 -94 1 11.0863 0.954938 5.00203 0.851153 5.26347 3.05665 -95 2 11.191 1.83687 4.62341 -3.02583 0.75042 -0.451702 -96 2 10.8235 0.406956 4.25776 -2.05383 -4.79736 -1.16032 -97 1 4.33613 2.85707 13.1911 1.54519 27.1095 -5.33994 -98 2 4.57692 3.1724 14.0657 0.352889 6.79614 0.336856 -99 2 4.2364 1.93118 13.308 -7.70759 -34.1778 4.58716 -100 1 8.4203 10.2079 1.80876 2.06346 -1.14808 -20.454 -101 2 8.303 10.9031 2.4489 -3.41662 7.51624 10.9075 -102 2 8.71506 9.44854 2.30018 2.97787 -12.0816 9.03727 -103 1 10.3977 1.70625 15.5267 1.73644 2.79304 1.06494 -104 2 11.3647 1.6343 15.5026 -8.09264 -2.44943 -3.11689 -105 2 10.0867 1.93234 14.6348 6.55478 -0.658466 2.12488 -106 1 2.65181 12.9273 7.85805 -0.311785 2.06689 -1.07798 -107 2 3.23228 13.5447 7.39928 3.74905 0.741997 1.40009 -108 2 1.98379 12.6968 7.20259 -0.999427 -0.794231 1.07688 -109 1 3.77953 11.641 5.00453 4.18201 7.36008 7.19136 -110 2 3.61117 10.803 5.43181 -1.00449 -4.29555 7.12479 -111 2 2.98088 11.8656 4.52857 -4.84381 -0.0516249 -5.594 -112 1 6.70671 14.4383 16.9441 -2.88793 7.65462 4.66357 -113 2 7.46032 14.9632 17.2378 1.25427 -2.15328 -4.6823 -114 2 6.29331 14.8741 16.1864 7.83964 -2.53039 -3.71142 -115 1 14.1974 14.5272 3.32557 -8.64957 0.126228 1.77541 -116 2 13.6145 15.2324 2.99689 6.18241 -4.15847 9.95625 -117 2 13.7792 14.1343 4.11346 2.7139 4.36583 -10.9531 -118 1 8.49626 18.0895 16.0579 -56.9361 5.6973 -1.31016 -119 2 8.97799 17.2887 16.1101 31.3098 -20.0295 7.70991 -120 2 8.99116 0.248943 16.0582 28.7181 13.2998 -3.6499 -121 1 4.72072 1.70195 4.90499 9.17194 -24.9679 14.1726 -122 2 3.98364 2.22531 5.16555 -23.8501 10.7625 5.04957 -123 2 5.10611 2.17516 4.19081 15.0133 13.348 -19.3674 -124 1 15.0233 12.5839 16.4881 -18.3113 17.2758 -0.569629 -125 2 14.531 13.0978 17.1312 10.6463 -2.17552 11.3526 -126 2 14.3728 12.5238 15.7796 8.99848 -7.00837 -8.88439 -127 1 15.6995 18.4783 16.8755 -18.8856 10.9503 -24.4051 -128 2 16.4938 18.4127 17.3644 26.3461 0.942046 24.9737 -129 2 15.418 17.5728 16.7613 -4.49112 -11.2036 -1.17338 -130 1 1.28835 1.23059 16.5761 -5.93248 -0.138309 0.14802 -131 2 2.13994 1.64325 16.7078 7.79309 6.58334 -0.470261 -132 2 0.740967 1.66098 17.2372 -5.253 -1.12337 3.85618 -133 1 18.1629 4.44327 15.9115 -6.79632 -1.27318 -1.28488 -134 2 18.1308 3.86521 15.1462 0.0573414 -0.0912133 -1.44422 -135 2 0.437875 4.54116 16.1499 5.78898 1.89854 1.50737 -136 1 12.2373 17.0002 16.1546 0.545523 9.79929 -13.3931 -137 2 11.4461 16.6427 16.5433 -11.0844 -6.7728 9.10484 -138 2 12.011 17.1373 15.2222 3.0182 -2.09591 3.06353 -139 1 16.0678 2.55904 18.1722 10.2246 -6.29614 14.7907 -140 2 15.8342 3.46829 18.3235 -8.81825 14.1289 4.59946 -141 2 15.8732 2.39245 17.2622 -4.4601 -2.08833 -19.809 -142 1 6.72425 13.805 10.1648 -2.60578 6.66979 -6.33116 -143 2 6.49371 13.5045 11.0525 -0.564993 -6.25943 -2.37403 -144 2 6.44263 13.1457 9.51237 3.71898 -2.3263 8.04067 -145 1 10.1796 18.3897 2.72456 -2.84724 -9.82946 6.47371 -146 2 10.454 0.395639 2.08514 4.83004 8.04726 -9.16723 -147 2 9.37175 18.0281 2.35385 -6.15379 0.681222 3.71385 -148 1 3.03584 17.7169 6.12875 -8.09623 -9.32203 -7.45056 -149 2 2.18289 17.4189 5.74043 17.1828 11.6191 3.33552 -150 2 3.689 17.6882 5.40781 -11.2408 2.0569 5.59443 -151 1 12.6056 16.8615 7.96971 24.61 3.09247 -20.49 -152 2 12.0094 16.1192 7.91607 -18.906 -3.75998 3.49802 -153 2 12.4208 17.4479 8.69718 -9.87831 1.59818 13.2946 -154 1 14.8851 15.258 8.17849 4.86996 1.69705 3.53461 -155 2 13.9994 15.6489 8.25275 11.2692 6.96129 -5.86816 -156 2 15.346 15.6481 7.40987 -12.7499 -9.2219 7.50011 -157 1 17.7579 18.2305 0.335063 13.8809 -6.66068 -7.77561 -158 2 18.5388 17.6427 0.115787 -18.9695 29.962 7.44433 -159 2 18.0215 0.522838 0.460167 3.90753 -19.2563 -2.82208 -160 1 0.789759 10.4825 1.35847 3.51968 14.2812 -7.72333 -161 2 0.0798625 9.88631 1.6077 -6.45512 -1.46576 0.207918 -162 2 0.407025 11.2033 0.810215 7.48025 -15.8311 11.8414 -163 1 1.75759 12.251 3.36651 -3.2997 0.800224 -5.24767 -164 2 1.53389 11.5715 2.69671 0.947411 14.52 5.02147 -165 2 1.90006 13.112 2.93145 -3.03991 -14.1386 -4.6936 -166 1 0.626528 17.2392 4.94747 0.535799 -10.8391 4.53682 -167 2 18.8821 18.137 4.96158 -2.27873 -17.8214 11.6149 -168 2 0.354378 16.6324 5.68648 2.97307 28.5848 -17.7586 -169 1 1.10952 0.863641 9.39152 -13.7339 -4.40866 12.9037 -170 2 1.31873 0.587529 10.3088 -1.45288 2.90017 -16.0983 -171 2 0.209028 0.525909 9.24512 10.3392 4.25606 -0.349363 -172 1 16.7392 2.34887 13.3076 6.86896 9.31967 14.159 -173 2 16.9447 2.54868 12.3949 -1.60073 1.25233 -7.99088 -174 2 16.5723 1.40956 13.3727 -4.20045 -10.3799 -4.26178 -175 1 2.67499 15.8791 12.0838 -15.6649 13.6026 18.6328 -176 2 3.08767 15.4473 12.8331 1.25238 -1.62775 -1.314 -177 2 3.09072 15.5563 11.2931 8.09534 -6.35014 -12.1736 -178 1 16.4274 15.6453 6.10859 -17.0431 -16.804 0.948824 -179 2 17.3058 15.6768 6.44562 21.0308 -4.79075 10.9 -180 2 16.4023 16.3397 5.46924 -8.03031 15.1286 -15.2988 -181 1 5.80151 5.1106 11.8034 -9.99749 12.6805 7.50019 -182 2 5.41461 5.91177 12.2246 6.41162 -14.9692 -6.22456 -183 2 5.12172 4.42339 11.8362 4.25931 3.80702 2.95737 -184 1 15.1575 4.86793 0.802761 22.7174 4.42582 -27.0135 -185 2 14.9254 4.50834 1.64009 -5.31496 -5.26411 26.4075 -186 2 14.3858 5.30472 0.469017 -12.1413 5.82456 -3.82743 -187 1 16.3769 16.3844 2.01422 -5.72057 14.22 1.10565 -188 2 15.9278 16.7493 2.80314 10.8683 -6.01604 -9.24812 -189 2 16.773 17.1531 1.56448 -5.22082 -7.76197 3.40899 -190 1 0.23965 4.83003 3.84895 -16.8427 -30.7507 -16.2196 -191 2 0.252698 5.75131 3.99923 2.34384 38.0203 4.84997 -192 2 0.859131 4.45396 4.45569 14.7994 -7.19156 9.40612 -193 1 2.95205 15.0559 15.135 12.255 2.89982 -34.0079 -194 2 2.82691 14.77 16.0276 -6.33331 -2.96333 21.8089 -195 2 2.70057 15.9867 15.0833 -9.42631 -1.00353 7.2626 -196 1 1.12786 14.6523 9.50314 0.137917 -12.6668 4.07712 -197 2 1.90226 14.1941 9.14772 -4.18616 2.58129 -2.64264 -198 2 0.826039 14.044 10.1958 0.138103 8.11094 -6.03497 -199 1 13.5191 16.5585 11.5327 7.73147 -8.17374 8.97592 -200 2 13.1298 17.2703 11.0385 -2.21772 17.726 -8.86187 -201 2 13.0359 15.7976 11.2032 2.83922 -8.38127 -1.58332 -202 1 4.66669 1.44213 0.750789 16.1276 9.43437 -4.32571 -203 2 4.14083 2.03292 0.213208 -5.20243 5.56453 -6.36037 -204 2 4.0469 0.85314 1.17877 -1.04658 -3.40534 3.74731 -205 1 1.47829 18.5621 11.858 5.51121 1.25702 19.3245 -206 2 1.35114 0.550992 12.5892 2.53269 -8.70306 -5.34898 -207 2 2.06733 17.8728 12.2103 -6.7512 4.69931 -6.32602 -208 1 11.4685 10.1386 3.99675 -31.6511 -19.8648 40.1611 -209 2 11.3534 10.4173 3.11507 -1.88937 16.5167 -32.0622 -210 2 12.3922 10.1317 4.15588 31.92 0.339396 6.83567 -211 1 8.2329 12.185 3.6562 14.6677 -4.21505 -16.0366 -212 2 9.0609 12.5679 3.94713 7.11932 4.3628 2.52934 -213 2 7.63223 12.3212 4.36927 -17.6963 1.05811 24.4992 -214 1 14.5368 4.0151 3.29112 -13.123 -7.80297 -23.8392 -215 2 15.0981 3.94713 4.04639 13.729 3.5857 20.4451 -216 2 13.7669 4.51912 3.55347 -6.0046 4.6829 5.42155 -217 1 5.65486 1.65777 7.52148 58.4475 40.9395 -13.9317 -218 2 4.99661 1.25201 7.99959 -53.8788 -37.1346 38.2946 -219 2 5.51095 1.40377 6.61889 -5.49301 1.61126 -19.8188 -220 1 17.8901 1.045 4.84749 -9.94718 -16.9222 0.488244 -221 2 18.5122 1.52388 4.30334 5.34684 7.49098 -3.2278 -222 2 17.6047 1.57034 5.59464 4.63979 8.2364 3.24002 -223 1 6.81309 9.39039 4.50819 3.0131 -8.49785 6.19054 -224 2 6.80308 9.57416 5.46384 1.81054 -3.72037 -9.62081 -225 2 7.68859 9.02244 4.29465 -5.74329 4.97879 4.89484 -226 1 2.5752 14.8387 1.99973 -14.8295 0.871449 -1.75437 -227 2 3.26878 14.7632 2.65166 10.803 -1.54702 2.65568 -228 2 2.97003 14.8559 1.12279 1.99123 -2.02101 2.0261 -229 1 17.298 12.9204 13.1492 -3.4846 16.1956 -6.51124 -230 2 16.423 13.308 13.3278 8.68723 -6.18077 0.438899 -231 2 17.8438 13.7012 12.9334 -6.61166 -12.0077 2.21466 -232 1 14.9034 10.5534 1.40093 -1.35277 29.2651 19.5565 -233 2 15.388 11.3453 1.77149 -13.4573 -26.0533 -12.1606 -234 2 13.9634 10.6773 1.62965 16.0361 -2.08776 -5.28169 -235 1 5.72986 6.65162 4.58435 -17.0557 15.5593 -6.14164 -236 2 5.84842 7.61417 4.55049 3.33824 -4.32419 -0.681988 -237 2 6.28697 6.32726 5.29234 8.09232 -2.61709 -0.816212 -238 1 7.99944 8.35521 10.3848 17.9936 -2.63811 -6.27588 -239 2 8.59251 9.07404 10.0893 -6.48701 -11.154 -5.32581 -240 2 7.88909 7.71789 9.66296 -2.42609 11.6503 -0.200638 -241 1 13.4241 18.44 5.69275 23.5538 0.0525075 -9.71433 -242 2 12.6953 0.391603 5.53139 -12.0458 3.72648 -1.32391 -243 2 13.2482 18.017 6.52624 -8.74326 -11.7295 10.7578 -244 1 0.0158155 2.64508 0.27395 14.5716 -58.678 15.8132 -245 2 17.7841 2.79898 -0.0392974 -21.1138 14.4347 -10.6776 -246 2 0.56739 3.397 0.238244 13.7063 38.8805 -4.38724 -247 1 12.8888 11.0203 9.74081 14.4921 -25.5472 6.65601 -248 2 11.9442 11.0265 9.60333 -9.9467 -3.56544 -1.05488 -249 2 13.1018 10.1085 10.0646 -8.85698 19.3484 -7.35591 -250 1 0.676749 12.1402 11.0769 -15.7222 13.4662 19.3247 -251 2 18.361 12.1632 11.2371 5.51909 -2.16069 -8.49445 -252 2 1.03381 12.419 11.9274 8.68848 0.134808 -1.80861 -253 1 5.1281 7.32638 13.4074 12.574 7.81643 0.126088 -254 2 5.56178 8.11083 13.0117 -0.574951 -12.9077 2.36295 -255 2 5.67541 7.10745 14.1812 -7.25639 3.83801 -6.5213 -256 1 1.19691 6.83481 11.9192 5.63437 23.0857 0.0567084 -257 2 0.430704 7.22717 11.4609 12.0202 -4.44614 6.83847 -258 2 1.80476 7.59103 12.1282 -18.5438 -19.7012 -5.0003 -259 1 15.5112 9.6605 12.308 7.39931 -23.3592 2.14975 -260 2 15.3284 10.5626 12.1388 -11.1565 28.2269 -10.7029 -261 2 15.46 9.608 13.2546 2.72926 -7.26454 12.4411 -262 1 16.5981 12.7055 5.55132 5.93792 -6.99565 4.13948 -263 2 16.3871 13.6216 5.72312 -3.40713 11.8574 1.85996 -264 2 16.4508 12.5854 4.61105 -1.1211 0.407027 -8.19974 -265 1 6.341 9.80883 0.0188309 -5.87145 18.2236 11.3739 -266 2 5.58583 10.3592 0.271383 3.51693 -3.70717 1.01998 -267 2 6.97723 9.90576 0.746734 -2.19026 0.0209431 -7.09875 -268 1 12.2976 6.11648 4.05009 -7.99316 6.14403 -18.1211 -269 2 12.258 6.83685 3.38221 3.50754 -15.1435 11.6411 -270 2 11.4736 5.62673 3.91242 4.22123 1.1153 4.56647 -271 1 0.341758 12.8367 0.152932 -4.41368 -4.71323 -6.18075 -272 2 -0.071293 13.3938 0.818389 4.38543 6.64898 2.3316 -273 2 18.4831 12.9746 17.9873 -4.56942 3.87447 -1.94524 -274 1 3.61813 18.6313 8.61443 0.661139 8.76689 2.03667 -275 2 3.46056 18.3752 7.69711 -0.554223 -6.30588 2.24303 -276 2 2.77043 0.354615 8.90695 5.13325 -4.08936 -2.3138 -277 1 7.42355 17.3409 4.4768 -7.56741 1.42105 -0.716546 -278 2 7.51902 18.2689 4.68925 3.30463 5.13228 6.51734 -279 2 7.58206 17.32 3.5353 -0.521854 -4.80047 -8.50069 -280 1 9.24832 17.1301 12.2139 -13.1815 7.8308 -4.22869 -281 2 9.33905 16.301 11.7591 -2.0028 -14.1862 -9.75618 -282 2 10.0447 17.2202 12.718 16.3553 3.99578 13.5609 -283 1 13.2894 13.0415 8.03267 8.35671 10.0486 -9.41069 -284 2 13.3695 12.1786 8.4589 5.84428 6.69767 4.94138 -285 2 14.1604 13.5085 8.0433 -18.6948 -10.3528 3.9365 -286 1 14.8481 2.99092 15.3927 0.856118 4.40098 19.7153 -287 2 14.1706 2.3196 15.3374 -5.14829 -8.82459 -5.54141 -288 2 15.3789 2.92995 14.603 5.00888 -0.952448 -11.2281 -289 1 9.90287 15.5907 16.9887 3.86064 7.54266 0.708681 -290 2 10.4376 14.8321 16.7196 -3.05759 -5.14225 0.11478 -291 2 9.69704 15.4836 17.9287 -2.19155 -3.5869 -5.21272 -292 1 11.3068 8.44228 16.6046 -8.18504 -5.87812 -2.49231 -293 2 10.7375 7.86962 16.0559 4.371 7.7216 8.33293 -294 2 11.2933 8.06373 17.4959 1.16379 -1.60832 -8.83864 -295 1 4.00007 18.2264 16.7774 4.24494 10.2639 17.5421 -296 2 4.56172 17.6396 17.2965 -1.57319 -6.32646 -5.9019 -297 2 3.85664 0.302165 17.4089 -1.12143 -0.586814 -11.7526 -298 1 2.2479 4.22742 8.91978 -15.7964 -0.236851 -9.315 -299 2 3.17417 4.26053 8.71033 14.3134 -0.385935 -1.23962 -300 2 2.16897 4.01078 9.84529 1.80454 -0.809508 12.1296 -301 1 9.87751 10.3883 9.74788 10.9603 -30.3507 -6.41167 -302 2 9.55849 11.2198 9.44401 -12.062 25.9436 -6.06801 -303 2 10.0779 10.4258 10.6774 1.92757 5.46095 17.7276 -304 1 9.69765 0.927205 10.8701 14.9831 -0.992619 -3.75191 -305 2 9.43595 0.039964 11.1566 -10.0783 4.56951 -4.94264 -306 2 9.12787 1.25731 10.1583 -1.53115 -8.98556 4.28196 -307 1 9.19006 15.088 10.2066 22.8811 13.4843 7.03893 -308 2 8.82905 15.9231 9.90375 -5.23887 5.212 -7.88342 -309 2 8.4517 14.4971 10.2333 -16.9878 -12.2258 -0.936878 -310 1 0.910091 9.64474 10.2618 6.35784 -25.2235 -17.0921 -311 2 0.848571 10.4636 10.7331 2.68282 16.4495 1.28733 -312 2 1.6853 9.71195 9.67503 -11.8234 -0.16557 12.5577 -313 1 17.0493 4.85425 8.1315 23.124 -12.0189 -22.071 -314 2 16.5036 5.57379 8.38464 -19.6085 19.0848 9.20549 -315 2 17.0051 4.2127 8.82658 -1.69519 -7.20825 12.6053 -316 1 14.7684 14.7087 0.123438 -2.69691 -12.5371 -11.3918 -317 2 15.061 15.3506 0.758659 10.1685 10.0196 13.4831 -318 2 13.9556 14.337 0.462955 -8.28455 -4.39651 5.72223 -319 1 3.75153 11.0481 9.53582 4.71209 -10.2499 1.98044 -320 2 3.63189 11.3357 10.4456 -0.734234 5.70871 5.17654 -321 2 3.24354 11.632 8.96907 -2.43681 8.8531 -2.47663 -322 1 11.2519 10.7463 1.5017 8.48932 -12.5201 -0.266865 -323 2 11.5908 11.5519 1.12329 1.64528 14.0457 -7.10687 -324 2 10.3311 10.688 1.26079 -12.3399 1.77059 -3.9568 -325 1 13.1496 7.17281 12.6854 5.50111 -7.8338 2.87732 -326 2 14.101 6.95885 12.7444 -10.2033 1.82309 -0.47089 -327 2 12.6663 6.34751 12.851 5.63542 3.55 -1.50526 -328 1 9.61828 1.90104 0.967862 -1.73511 6.80555 -16.7575 -329 2 8.75126 1.82608 0.511852 18.7109 -2.38487 5.6602 -330 2 10.2637 2.29933 0.349253 -13.3131 -4.11214 4.99441 -331 1 10.6435 13.4896 4.54607 -8.3754 1.2658 -1.96254 -332 2 11.4795 13.0515 4.69791 8.28938 -6.58305 0.731496 -333 2 10.5798 14.1432 5.24738 -1.32643 -0.553656 5.74704 -334 1 14.4543 1.71115 10.9546 -7.69161 -4.81009 -3.91494 -335 2 15.2136 1.28396 10.5547 4.80162 -2.13195 -1.67599 -336 2 14.6015 2.65135 10.8079 -1.60778 0.935868 6.54178 -337 1 14.5384 12.1186 11.6682 4.42158 0.0609916 50.1985 -338 2 15.3244 12.3738 11.2188 19.3883 10.0258 -22.7848 -339 2 13.838 12.0043 11.0592 -19.2299 -5.1918 -28.9193 -340 1 8.19636 5.07775 9.81895 6.92668 -2.08004 -5.22277 -341 2 7.38544 5.24812 10.3055 -3.33886 -3.05544 1.61921 -342 2 8.19204 4.12852 9.59915 -2.53054 10.0553 1.98192 -343 1 1.48663 16.8897 18.439 7.38955 -7.44055 -8.00122 -344 2 1.97341 17.2271 17.6702 -6.10601 -1.16576 3.12224 -345 2 1.43805 15.9298 18.2902 4.85843 10.0488 4.15854 -346 1 1.49392 17.3013 15.324 -13.7543 10.7593 4.06087 -347 2 1.44447 18.24 15.6259 -3.67575 -24.1287 -4.86768 -348 2 0.590882 16.9129 15.3122 14.6177 13.551 2.26757 -349 1 3.61646 5.75696 6.06482 3.05275 -16.2413 -2.75756 -350 2 3.17 6.32551 6.68313 -10.4039 6.81614 9.87761 -351 2 4.1613 6.3181 5.51248 5.12466 2.54076 -5.58469 -352 1 12.4579 9.47416 14.2028 -15.1686 39.1263 4.59508 -353 2 12.91 8.74193 13.8564 21.0065 -34.4741 -21.4004 -354 2 12.311 9.21984 15.1046 -5.21536 -3.05923 17.073 -355 1 4.05954 15.2722 6.9713 -12.2847 -13.6907 9.03639 -356 2 3.52733 16.0267 6.71946 -3.69787 8.1984 -1.38185 -357 2 4.94462 15.4979 6.70957 17.3953 3.39893 0.124931 -358 1 0.676716 8.64845 15.0435 0.0448789 -8.8726 2.29819 -359 2 0.388517 9.55355 15.1457 -0.102902 11.258 0.0552156 -360 2 1.38121 8.67263 14.3922 3.78483 -0.0353447 -4.44966 -361 1 12.9131 8.29224 10.2146 2.07907 -10.3878 2.68575 -362 2 13.6346 7.78925 9.80195 -2.79275 5.95566 3.91371 -363 2 12.8029 7.87463 11.0885 3.60602 9.09063 -7.955 -364 1 15.3505 7.77425 3.51602 -25.105 2.18251 -0.815364 -365 2 14.4666 7.51634 3.2857 -7.66712 2.41401 -31.383 -366 2 15.2516 7.5997 4.43625 29.5189 -3.75051 28.1293 -367 1 17.2908 6.71242 0.0288264 8.4359 -0.0595562 3.38218 -368 2 16.7481 6.02838 0.414195 -4.41494 -10.5616 1.77026 -369 2 16.6696 7.39667 18.4317 -9.71571 9.06541 -4.14994 -370 1 8.93558 6.94317 7.77066 11.3734 11.9101 1.30985 -371 2 9.8513 7.28708 7.82315 -13.5624 -4.9569 -0.419932 -372 2 8.83457 6.3282 8.49913 -0.351333 -9.82053 6.39411 -373 1 12.3886 0.605922 1.26733 4.3474 1.63423 -5.64369 -374 2 13.3496 0.62067 1.39833 -3.50709 5.26207 -1.10414 -375 2 12.2365 0.554465 0.317002 3.44844 -5.08055 2.164 -376 1 5.6093 15.1332 14.5298 5.50237 -6.63524 -3.85361 -377 2 4.67729 15.3131 14.6547 -7.5977 -3.56809 4.17708 -378 2 5.99198 15.9265 14.1501 5.33744 7.17763 0.920224 -379 1 3.83862 6.42399 1.72255 -0.530245 0.761181 6.81888 -380 2 3.42185 7.23588 1.41886 -3.5948 7.2146 -3.68667 -381 2 3.94102 6.55655 2.67261 0.00170673 0.796504 -2.59346 -382 1 3.90756 11.5263 12.3817 0.20855 -7.47029 -8.65749 -383 2 4.79535 11.8927 12.4625 -0.681042 -1.53834 0.918823 -384 2 3.33577 12.1179 12.8713 -4.93373 1.57702 0.731635 -385 1 5.31593 3.88159 15.8542 -0.71358 -42.6288 -12.177 -386 2 5.97198 3.22378 15.5406 -6.31298 7.40988 7.32158 -387 2 5.73536 4.71214 15.7787 14.3185 32.9857 -0.935745 -388 1 14.2562 10.2258 4.56557 -18.8652 24.4894 6.04548 -389 2 14.4389 9.92543 5.45169 -1.13053 -5.88778 11.8213 -390 2 14.6954 9.63367 3.98806 17.1426 -20.2086 -20.2139 -391 1 7.6892 17.381 9.10447 19.4711 -25.2283 0.682627 -392 2 6.86971 17.6207 9.51632 -14.1206 10.5396 4.24559 -393 2 7.90224 17.9622 8.37374 -3.5427 12.2774 -4.18627 -394 1 4.51373 14.5018 3.89084 0.522587 -13.0056 -37.966 -395 2 4.5996 15.4052 4.14706 0.258928 20.2029 10.6105 -396 2 4.49773 13.963 4.65868 1.58881 -14.8294 26.2191 -397 1 14.2556 7.39762 15.8429 -9.24001 -8.17606 -10.1746 -398 2 15.1854 7.31956 15.6389 10.3704 -1.38951 -4.38862 -399 2 14.2355 7.83779 16.6857 -0.295639 4.56275 12.5602 -400 1 3.05453 18.3862 1.94671 -28.337 -27.777 -22.0693 -401 2 2.58101 17.7651 1.32015 15.7039 17.8808 20.6311 -402 2 2.35293 0.259745 2.36363 3.01847 1.93426 2.5363 -403 1 7.98344 1.63895 4.58298 -1.95289 -5.65456 5.83277 -404 2 7.39472 2.00993 3.91227 5.60846 -0.877805 -3.34347 -405 2 8.83104 1.39808 4.18815 -5.23209 5.3786 -4.6966 -406 1 2.44155 14.16 17.683 19.8901 20.6744 -11.1998 -407 2 1.71949 13.6284 17.9614 -19.7639 -16.6874 11.6615 -408 2 3.22651 13.6749 17.9404 10.3416 -4.56611 4.09925 -409 1 0.874431 1.8172 13.9017 -2.66591 2.98819 0.0720706 -410 2 0.796895 1.67216 14.8604 0.805718 -0.9226 -9.7327 -411 2 18.6311 1.96655 13.5402 2.6832 0.103556 9.2189 -412 1 4.40474 18.7103 13.8903 -4.51489 2.73844 -3.11833 -413 2 5.26066 18.332 13.6843 10.2731 -0.629088 3.90858 -414 2 4.27285 18.5624 14.8326 -2.10334 -1.04281 2.89108 -415 1 7.22541 0.768378 18.3802 -7.41292 5.22253 -10.0414 -416 2 7.14919 0.357851 17.5011 6.06274 3.8916 10.097 -417 2 6.39657 1.25171 18.5223 1.70256 -10.1891 2.75464 -418 1 16.0038 18.3833 13.9769 4.60778 -2.90009 -16.1733 -419 2 15.0678 18.3553 13.7682 -2.12799 2.80836 4.60244 -420 2 16.1189 18.6995 14.8699 -6.8859 -1.5785 15.9997 -421 1 10.1619 4.59436 16.2508 34.7775 -10.6887 1.26028 -422 2 11.1678 4.58362 16.2281 -36.3206 4.79489 -1.20103 -423 2 9.8959 3.67942 16.0718 3.3051 4.94693 0.644026 -424 1 15.9268 17.7185 4.48585 -0.443376 -19.9814 -7.77196 -425 2 16.5546 -0.221465 4.56619 12.2284 16.6263 -2.03126 -426 2 15.0862 18.0786 4.73637 -15.899 7.019 6.15678 -427 1 6.9987 17.4508 13.864 -28.5259 -4.03497 -9.84039 -428 2 7.52153 17.7102 14.6061 10.1765 7.77338 18.9538 -429 2 7.63162 17.2858 13.1766 11.9873 -1.11294 -13.1093 -430 1 13.256 6.47431 6.57718 13.0919 -2.27803 2.33044 -431 2 14.2181 6.68617 6.52776 -23.2683 -1.75779 -6.09518 -432 2 12.9031 6.34478 5.6793 8.47748 2.51219 6.97161 -433 1 7.82324 2.30197 9.35649 6.58131 4.23212 14.3466 -434 2 7.32826 2.17284 10.185 -1.16662 2.6949 -8.43976 -435 2 7.24342 2.0875 8.62812 -8.03625 -5.88123 -5.84644 -436 1 15.1686 14.8419 13.6961 6.6084 -8.9126 -6.67367 -437 2 14.8499 15.0658 14.5674 -3.29174 5.55862 10.3748 -438 2 14.9102 15.5355 13.091 -7.311 3.85237 -1.87114 -439 1 9.39203 8.3247 3.79765 -11.0731 4.19637 -5.3616 -440 2 10.2213 8.76913 3.95172 10.5135 8.75123 3.89829 -441 2 9.56922 7.39926 3.9554 -1.92777 -9.54221 1.11885 -442 1 17.7628 13.6056 16.4368 0.454101 -14.0132 9.10192 -443 2 16.8123 13.4442 16.4542 -1.43638 -1.23592 -2.30674 -444 2 17.8812 14.4042 15.9249 -1.89469 7.90276 -3.85648 -445 1 4.90818 10.546 2.83916 0.136377 -2.73925 -10.4847 -446 2 5.60998 10.1288 3.34488 4.96678 -0.616571 0.115447 -447 2 4.51664 11.1769 3.44738 0.912314 1.46625 2.09919 -448 1 3.71104 8.38719 10.068 0.753133 0.0228827 -3.76935 -449 2 3.89927 9.29887 9.80067 -2.70003 -3.09285 3.15772 -450 2 3.67512 8.396 11.0298 -2.24059 1.87779 0.37074 -451 1 15.9565 6.94095 5.99865 -8.76526 9.77307 4.96327 -452 2 16.7516 7.41234 6.24421 7.68049 3.9133 2.85915 -453 2 16.2393 6.06165 5.75492 3.70751 -7.34759 -2.0072 -454 1 15.1339 7.14501 9.07066 -1.17949 -23.8082 27.0602 -455 2 15.8283 7.58235 9.55517 11.4438 5.0236 10.3868 -456 2 15.1116 7.57875 8.25013 -4.20744 20.1878 -38.3409 -457 1 6.25297 12.9267 12.7452 -4.72449 1.01458 -5.57239 -458 2 6.98991 12.3599 12.9819 6.62509 -1.61272 7.49964 -459 2 6.12032 13.5727 13.4468 2.47956 2.45399 3.39123 -460 1 12.1116 4.51066 13.1059 -15.4407 -10.6836 -10.9314 -461 2 12.4271 4.59486 14.0171 -10.4637 -2.65404 1.19035 -462 2 11.2547 4.00523 13.0473 26.1752 13.1928 8.83048 -463 1 11.3958 8.13336 7.91828 -4.43196 -2.05658 -14.2843 -464 2 11.9753 7.54394 7.4184 3.39578 1.92795 -0.521112 -465 2 11.8257 8.23937 8.76441 1.22007 0.905858 11.3028 -466 1 17.1296 10.8754 7.54699 -15.2323 -0.655909 3.97588 -467 2 17.811 10.2663 7.31344 17.8297 -18.4071 -0.448075 -468 2 16.9935 11.379 6.74844 -4.7697 12.6356 -6.62113 -469 1 5.29547 18.1363 10.9421 18.5805 -0.935137 -5.10578 -470 2 4.88577 17.8485 11.7431 -9.76906 -7.6723 14.1577 -471 2 4.62403 18.0611 10.2783 -13.9129 1.88822 -17.2145 -472 1 7.59234 17.5076 1.75687 4.86523 1.07577 -14.9702 -473 2 8.00304 16.7666 1.28453 -8.52174 0.253094 2.89961 -474 2 7.35564 18.1425 1.05706 3.89665 -2.44167 8.83688 -475 1 1.92302 12.8778 13.5789 2.91886 3.94981 -7.24471 -476 2 1.45818 12.4106 14.2651 -5.47786 -10.2367 6.99308 -477 2 2.33812 13.6191 14.0211 -0.459782 9.91978 4.14062 -478 1 9.50973 6.75636 14.7983 0.267759 -13.8501 3.13598 -479 2 9.76861 5.87974 15.1842 -3.78976 20.025 -16.8859 -480 2 9.67323 6.78366 13.8359 6.07296 -1.5477 12.5306 -481 1 15.3007 4.25662 10.7816 1.6835 6.93604 -0.852744 -482 2 16.2201 3.94716 10.8841 -13.758 11.9338 1.00514 -483 2 15.2044 5.07319 11.3041 5.68258 -12.2185 -1.66994 -484 1 11.2682 6.20917 0.148653 5.11845 2.03204 -0.614283 -485 2 11.4613 5.3156 18.5351 10.8417 -13.6045 -1.35957 -486 2 10.3344 6.26425 -0.02153 -13.2524 10.0913 1.35666 -487 1 -0.0515508 11.3921 15.0043 28.8186 -12.3739 35.7691 -488 2 18.1888 11.7008 14.2289 -27.1505 12.4881 -39.8426 -489 2 -0.144753 12.1488 15.5889 -3.39882 3.34168 7.51926 -490 1 7.01363 9.26741 7.30523 1.11866 9.50703 -8.15996 -491 2 6.64493 8.42979 7.58084 -4.10674 -7.85165 7.60391 -492 2 7.94964 9.11568 7.16987 5.72986 -2.82238 2.51511 -493 1 18.3266 15.3189 12.3109 1.98396 7.8422 -1.62162 -494 2 0.557814 15.686 12.1521 7.34904 -2.57966 -0.481227 -495 2 17.7488 15.821 11.7275 -2.3238 -0.409324 -3.46342 -496 1 16.5074 4.41847 5.29023 -12.2776 2.5176 -39.1335 -497 2 16.8214 4.00292 6.06235 10.453 -12.003 36.2431 -498 2 17.1989 4.29433 4.62557 3.70164 8.40848 3.22117 -499 1 17.7062 3.18115 10.7633 -10.0415 -0.498888 0.968384 -500 2 18.5829 3.451 11.0307 13.8857 -2.29821 0.377097 -501 2 17.7544 2.33603 10.3089 5.51555 -4.87272 -1.50428 -502 1 12.31 -0.0249004 10.0958 7.06597 -29.3992 -7.90418 -503 2 11.4091 0.228435 10.2265 -21.0592 11.9526 6.39906 -504 2 12.8361 0.735194 10.2786 15.1995 22.0824 4.66414 -505 1 10.3672 9.76964 12.4555 1.27225 -3.68083 -7.54967 -506 2 11.1341 9.82258 13.035 0.839453 -0.704743 2.83749 -507 2 10.2702 8.82174 12.2801 -0.554943 5.543 3.04928 -508 1 0.65465 2.77798 7.04528 -2.13863 -3.2199 7.00126 -509 2 0.891211 3.42266 7.72053 -0.0150652 2.55779 -0.825415 -510 2 0.990123 1.95336 7.40694 -1.54003 -2.33595 0.508806 -511 1 0.295674 15.3348 6.84982 -3.22172 27.5014 26.3495 -512 2 0.521244 15.1551 7.76985 -0.748412 3.60522 3.47657 -513 2 0.484365 14.5358 6.4159 11.6769 -37.1534 -21.5269 -514 1 17.0573 6.99129 15.1128 -10.0859 0.519269 -2.81001 -515 2 17.7626 7.64158 14.9811 2.36054 -7.88383 3.70046 -516 2 17.4128 6.20418 15.5441 6.5971 2.49163 -1.29874 -517 1 9.10445 12.4501 8.04005 25.0355 12.8023 20.768 -518 2 9.46092 11.7782 7.45434 -7.91968 -3.65307 -8.74082 -519 2 8.16829 12.5393 7.95206 -19.3694 -6.70788 -7.44718 -520 1 1.22811 1.76814 2.9182 -6.11732 -10.0295 -0.237983 -521 2 0.712195 2.08081 2.16479 2.12402 6.69579 0.750032 -522 2 1.58605 2.52034 3.3947 3.99278 5.86411 -0.360805 -523 1 4.10894 15.0956 9.93451 6.69744 -1.75099 -1.18621 -524 2 3.96901 15.3261 9.00671 4.91376 -1.44666 0.188494 -525 2 5.04659 14.871 10.0423 -6.23862 1.0691 -5.37016 -526 1 7.35274 2.18983 14.6875 -7.358 8.13743 -4.11606 -527 2 7.08638 1.65776 13.9297 0.32385 -1.91134 2.32143 -528 2 7.57979 3.04743 14.3014 5.83731 -4.25907 3.58957 -529 1 18.4915 14.5922 2.16266 -14.7631 20.4811 3.31696 -530 2 0.685462 15.0501 2.31645 0.801171 -7.89169 -2.84158 -531 2 17.8141 15.3012 2.20781 8.07106 -12.7893 -1.48401 -532 1 9.99475 2.73128 12.8993 -0.14498 6.34622 4.34107 -533 2 9.94968 2.10764 12.1674 -2.02697 0.25981 -1.25528 -534 2 9.23805 3.32791 12.8055 1.37719 -5.85529 0.104676 -535 1 2.96937 8.88969 13.0348 8.45161 15.4602 -1.6792 -536 2 3.19044 9.8379 12.866 -0.537566 -21.2484 3.2835 -537 2 3.7799 8.47356 13.3849 -14.589 3.50084 -4.12479 -538 1 3.21 8.56161 3.75492 -0.42537 -8.47878 -37.7314 -539 2 3.66747 9.30861 3.32521 -2.76458 -7.90594 7.43156 -540 2 3.22415 8.6869 4.6856 3.07128 8.62247 25.8231 -541 1 5.62342 7.20688 8.60781 8.60088 8.53717 -11.0276 -542 2 5.53536 6.26871 8.41561 -2.891 -1.4677 7.62716 -543 2 4.92494 7.48858 9.21156 2.86443 -6.54236 0.635755 -544 1 14.9008 1.47426 1.89198 -2.54888 27.9205 4.61998 -545 2 14.5535 2.29499 2.28075 -2.57285 -15.9361 9.92214 -546 2 15.4844 1.8547 1.23467 3.18874 -15.0862 -12.382 -547 1 8.48736 15.1158 0.783841 -1.15568 2.93173 4.22404 -548 2 9.1238 15.1934 1.5071 4.62293 -5.62872 -5.40551 -549 2 7.79285 14.5509 1.14844 -2.73481 2.50701 -2.31707 -550 1 15.539 1.37952 7.19688 19.4515 3.6409 9.83231 -551 2 14.9389 0.78101 6.7773 -13.8468 -10.3512 -10.8641 -552 2 15.0003 2.07296 7.57775 -6.55979 11.3773 -1.03994 -553 1 5.01034 12.9912 18.4705 -11.9235 -4.12885 0.570622 -554 2 5.4698 12.9987 0.669061 0.312037 0.832023 7.43214 -555 2 5.59011 13.4721 17.8825 4.88062 -0.262691 -5.03625 -556 1 15.3764 8.57785 18.0866 -6.62354 -11.676 10.0569 -557 2 15.6805 9.14973 17.3909 9.52323 10.3388 -11.2321 -558 2 15.2475 9.1488 0.206008 -1.03261 3.33477 1.75561 -559 1 12.066 3.08414 18.3349 -10.3405 10.2428 -1.58162 -560 2 12.3601 2.47993 0.38654 4.70786 -1.39849 -7.75748 -561 2 12.2507 2.72995 17.4495 4.61736 -8.1861 15.8047 -562 1 13.1968 12.6883 5.15757 -0.336282 2.96846 2.60586 -563 2 13.7743 11.9999 4.79412 -5.71366 -0.326721 6.52296 -564 2 13.1697 12.5812 6.12031 6.45904 1.498 -4.43193 -565 1 6.0986 7.21596 0.138974 -12.0498 11.3036 0.237585 -566 2 5.91833 8.16028 -0.0709607 9.65884 -21.2748 10.0237 -567 2 5.34258 6.95155 0.690129 5.85049 -3.44248 -7.26534 -568 1 17.7044 15.8891 14.9714 -7.43083 8.66678 -26.2685 -569 2 16.7907 16.1885 14.8618 6.06094 -1.91119 12.6189 -570 2 17.95 15.7638 14.036 5.46338 -3.82161 12.7361 -571 1 13.1509 0.939295 16.6327 -8.19033 8.72571 -1.54201 -572 2 14.0859 0.833936 16.7968 10.9207 -0.957234 5.29932 -573 2 12.8431 0.0418051 16.5014 -5.83506 -5.32332 -1.35137 -574 1 10.9522 14.5534 7.35938 -9.11436 -19.3925 22.6665 -575 2 10.1531 14.2304 7.85485 20.6615 9.00594 -18.4516 -576 2 11.6365 13.8859 7.56325 -5.91964 10.2955 -7.71128 -577 1 17.5919 8.49388 2.10024 -0.0322199 -9.95032 2.76416 -578 2 16.7206 8.43914 2.53345 10.0393 -1.69965 -6.58888 -579 2 17.6862 7.68098 1.5623 -5.40062 15.1321 4.16518 -580 1 12.403 7.83298 1.98454 10.1699 2.43182 8.97059 -581 2 11.823 8.58837 2.10452 -0.914469 2.41145 -5.63632 -582 2 12.0432 7.27751 1.28772 -5.41827 0.0907324 -1.12401 -583 1 12.0169 14.6214 10.4613 22.6496 -4.80377 11.9203 -584 2 12.2953 14.2566 9.62296 -0.627137 -3.48742 -6.53871 -585 2 11.0904 14.7922 10.4232 -26.4922 1.86569 -7.97999 -586 1 6.79945 6.92747 15.5042 -19.94 -13.6896 0.562857 -587 2 7.71181 6.85747 15.2524 19.187 5.43316 -2.40109 -588 2 6.75196 7.52139 16.2502 2.78602 4.81827 4.32857 -589 1 8.02489 4.54706 13.3799 -9.17747 17.7449 0.879178 -590 2 7.13549 4.71954 13.0119 14.9133 -0.721221 -4.30494 -591 2 8.45659 5.41872 13.4818 -10.582 -17.269 -1.29002 -592 1 13.3893 12.1928 14.3557 -6.07818 9.44403 7.21842 -593 2 12.9754 11.3343 14.2402 3.84433 -8.34325 -3.30791 -594 2 13.789 12.4346 13.5154 0.839467 -1.50598 -4.68274 -595 1 14.6037 9.51924 7.26293 11.3016 8.32374 8.02904 -596 2 15.4883 9.92697 7.3747 -13.533 -2.89904 3.77438 -597 2 14.03 9.85877 7.96896 6.22863 -2.20078 -8.30261 -598 1 12.724 16.8794 3.24165 4.36843 -29.0517 -11.6906 -599 2 12.9143 17.2056 4.10583 4.58985 8.72699 22.0136 -600 2 12.2764 17.5776 2.79705 -13.1015 20.2627 -13.4405 -601 1 1.027 7.08618 17.3856 17.8688 -9.35062 9.83545 -602 2 0.150845 7.20834 17.7372 -11.0357 -5.72224 6.2597 -603 2 1.04228 7.56687 16.5674 -0.430665 10.2682 -15.3686 -604 1 12.9047 4.96423 15.6783 -31.9319 9.90183 -0.420667 -605 2 13.6101 4.38571 15.8945 27.3027 -16.194 0.870052 -606 2 13.2534 5.85423 15.7473 6.89498 8.57473 1.28829 -607 1 2.36359 3.37095 5.13131 13.5367 -21.0772 -51.8355 -608 2 1.78827 3.18983 5.83511 -26.0337 -9.2034 36.1161 -609 2 2.76982 4.19309 5.31063 16.9607 33.0577 11.3338 -610 1 8.25673 11.0457 13.6214 -29.0742 18.4766 -42.051 -611 2 8.3505 10.9269 14.5387 12.3752 -9.07103 37.7912 -612 2 9.04494 10.7715 13.1556 11.3248 -9.59576 5.23465 -613 1 12.933 1.51857 13.2538 -7.42773 -10.5209 16.1392 -614 2 13.555 1.47666 12.536 9.8649 3.44918 -12.9241 -615 2 12.6435 2.43109 13.2999 -2.22529 4.34734 -4.74481 -616 1 6.5593 13.6321 2.14465 -6.91915 6.53865 -12.6846 -617 2 5.89828 13.9136 2.78341 -2.94652 3.12599 2.20918 -618 2 7.14809 13.061 2.63026 6.2374 -5.23981 3.14213 -619 1 15.8933 6.50668 12.6624 16.2584 4.45316 -6.00807 -620 2 16.3963 7.03445 12.007 -8.38894 -8.88658 12.5353 -621 2 16.4415 6.50555 13.4748 -12.028 3.27562 -10.9527 -622 1 16.7983 0.717045 9.56947 3.68169 11.9749 4.12436 -623 2 16.6133 18.4601 9.81273 2.15246 -18.3954 6.85595 -624 2 16.3759 0.833391 8.71872 -3.66349 3.7587 -11.8412 -625 1 6.14397 11.6556 8.30338 8.0817 56.4015 -2.32443 -626 2 5.40727 11.3941 8.82366 -25.1595 -10.6153 12.4164 -627 2 6.54205 10.8782 7.99323 17.2725 -41.4748 -11.5815 -628 1 2.81032 8.69956 0.356218 24.742 -6.25 8.21391 -629 2 2.27105 8.19016 18.4013 -14.5977 -1.17978 -6.66412 -630 2 2.29881 9.42159 0.72289 -11.078 1.63045 0.198871 -631 1 10.1064 10.4292 6.59515 -4.60438 -3.93729 0.830471 -632 2 10.5227 9.70923 7.07758 4.69601 -3.0134 2.20114 -633 2 10.434 10.3774 5.69507 4.10481 0.747976 -4.90006 -634 1 6.80466 15.7541 6.67201 6.06476 3.31695 -2.74514 -635 2 7.12474 16.199 7.46137 -2.48244 -3.95514 6.52968 -636 2 7.21004 16.2686 5.96286 -5.79252 -2.21211 -4.39766 -637 1 6.45958 12.986 5.74076 6.97467 7.4921 0.177054 -638 2 6.67553 13.8767 6.05203 0.11849 -2.56514 -0.0944634 -639 2 6.15828 12.5051 6.51647 -3.32664 -1.56183 1.61673 -640 1 16.774 12.5213 9.71798 -12.6143 2.89661 19.2402 -641 2 17.0082 11.8947 9.03708 5.67192 -3.35034 -8.73073 -642 2 17.3962 13.2453 9.69208 4.02202 2.48097 -6.52464 -643 1 6.17384 2.92225 2.79448 3.9775 16.0199 -22.3947 -644 2 6.54801 3.78326 2.49667 -7.94175 -14.5768 11.9424 -645 2 5.69703 2.59738 2.01124 2.48224 -4.95439 10.1002 -646 1 10.7977 3.13994 3.23713 3.9771 -4.26255 2.57443 -647 2 10.0782 3.73781 3.45741 -0.0760182 2.97522 -1.01161 -648 2 10.5069 2.61778 2.47973 -3.48459 4.35709 1.40724 -ITEM: TIMESTEP -70 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.80152 6.81783 17.9876 -13.1435 8.65537 6.0931 -2 2 7.93927 7.0215 18.3978 9.39494 -6.73756 -6.11522 -3 2 8.64173 6.15327 17.319 -1.79792 -4.8767 -3.2487 -4 1 0.159104 8.33212 6.75565 -1.75886 1.86255 -0.283403 -5 2 0.400553 7.98898 5.87058 -1.56937 3.6046 13.6337 -6 2 0.532733 7.75931 7.44677 0.588181 -1.3305 -10.9259 -7 1 8.56014 0.2064 6.86713 15.1827 -2.1442 1.30375 -8 2 9.48839 0.201881 6.58247 -8.47619 -0.963055 4.35965 -9 2 8.1657 0.891093 6.32874 -5.18544 5.82437 -2.7504 -10 1 6.48158 1.74839 11.7303 -5.73112 -6.99234 -4.49671 -11 2 5.77966 2.25139 12.1582 1.03612 1.63173 -0.79005 -12 2 6.04661 0.9684 11.3341 5.10627 10.6526 7.94811 -13 1 6.96595 5.58057 2.38836 1.68885 13.6464 8.05547 -14 2 6.50498 5.94206 3.17078 2.94101 -7.34901 -12.8293 -15 2 6.93975 6.29059 1.72807 -1.07971 -9.74986 0.444847 -16 1 16.2371 10.2379 16.1019 -30.9876 -7.62323 7.88585 -17 2 17.0175 10.5802 15.7054 20.7335 11.057 -7.58035 -18 2 15.6477 10.9912 16.2983 15.508 -10.4523 -2.02188 -19 1 10.7008 14.9379 2.28795 4.31472 -8.51672 3.50984 -20 2 10.6635 14.2367 2.95607 -1.08681 7.31624 0.965 -21 2 11.2207 15.6296 2.69467 3.48557 9.19098 3.66151 -22 1 17.1795 8.23023 10.7992 8.53416 -1.59534 -8.67541 -23 2 16.5643 8.83199 11.2261 -1.39923 4.26423 7.56567 -24 2 17.9421 8.77596 10.5426 -4.34729 -3.75626 -0.741474 -25 1 14.6688 15.978 16.4285 2.33326 -11.9168 -2.20454 -26 2 13.7825 16.2968 16.2522 -6.84331 1.16869 1.85073 -27 2 14.5784 15.3806 17.1932 6.40998 12.5602 -6.81985 -28 1 12.1084 13.347 0.550082 18.7888 -12.4001 5.31554 -29 2 11.808 13.4241 18.2861 -6.00468 7.05887 -5.4437 -30 2 11.724 14.0175 1.12482 -9.88619 2.03399 -6.75529 -31 1 9.30709 5.48775 3.90966 3.41698 -5.29876 17.2174 -32 2 8.77877 5.25688 4.68667 5.61339 2.83044 3.00189 -33 2 8.64592 5.55872 3.2299 -8.10772 2.16644 -16.0449 -34 1 1.64595 4.02425 11.592 -10.9656 22.1289 -13.9701 -35 2 1.60629 4.97108 11.8395 -0.824037 -11.4025 -3.90562 -36 2 2.20491 3.59841 12.2231 10.5337 -11.1868 16.6964 -37 1 2.06621 6.87149 8.22737 1.24172 3.77126 1.52806 -38 2 2.50304 7.30143 8.97949 -2.75541 -3.2118 -2.64013 -39 2 1.97282 5.93715 8.45613 -0.171499 4.52155 4.26063 -40 1 5.3374 4.4954 7.902 -9.99384 -2.48662 -4.40208 -41 2 5.3873 3.53885 7.92862 5.32096 -10.0353 0.506932 -42 2 4.78906 4.68538 7.13029 -0.632429 8.18831 0.496784 -43 1 3.33945 2.92164 17.4119 -9.04777 -8.0172 12.2496 -44 2 4.01569 3.37904 16.9228 10.8208 5.2633 -7.4392 -45 2 2.90871 3.59334 17.9575 0.609467 0.189965 -2.29637 -46 1 7.45919 5.40741 6.16401 6.01334 0.147035 -1.33637 -47 2 7.84933 5.9815 6.83711 3.51741 -4.84398 -5.3698 -48 2 7.00259 4.70355 6.63733 -2.11297 5.93299 1.70682 -49 1 9.81228 7.01862 12.0561 -1.06857 0.870105 -3.24483 -50 2 10.2542 6.3375 11.5392 -2.78202 1.90065 -0.0845581 -51 2 9.1292 7.39963 11.4807 2.35361 -4.5728 1.86322 -52 1 13.9947 3.68643 8.08173 -5.65395 18.5094 -17.1015 -53 2 13.7843 4.54079 7.64233 1.50666 -18.9 8.64197 -54 2 14.1479 3.8993 9.00085 4.5059 2.7709 6.99075 -55 1 4.5073 17.1442 3.93435 4.48768 -12.0008 8.39889 -56 2 5.39081 17.5321 3.92633 -2.26089 2.72179 -5.35255 -57 2 4.01543 17.3459 3.13072 5.98217 13.0117 -0.399635 -58 1 16.4079 16.585 10.4121 -12.3499 -1.91652 -12.9082 -59 2 15.5551 16.5364 10.8674 2.44262 -0.34105 -1.56006 -60 2 16.2254 16.2298 9.51738 1.66683 0.349555 15.5208 -61 1 1.97926 4.78245 0.194184 -7.72676 6.8376 3.32149 -62 2 2.28164 5.2243 0.992573 8.53964 -6.59001 3.21257 -63 2 1.76914 5.52567 18.27 -2.63275 2.53007 -9.16672 -64 1 11.4134 13.2491 16.3873 0.68902 5.27402 2.7566 -65 2 10.9787 12.3908 16.4988 0.445492 6.36744 -3.52589 -66 2 11.9797 13.161 15.6117 0.593117 -3.37138 0.847423 -67 1 10.1151 10.9818 16.8138 12.4788 0.931853 3.10073 -68 2 10.558 10.1255 16.7937 -4.12284 -0.882862 -0.541555 -69 2 9.18349 10.8105 16.7424 -13.6774 -3.43657 -1.9902 -70 1 11.7994 17.4667 13.4795 12.7765 -4.5476 -2.07039 -71 2 12.3346 16.8373 12.9682 -4.67996 5.77396 2.18605 -72 2 12.2169 18.3179 13.2967 -7.11407 5.85224 3.16387 -73 1 6.41771 9.40938 12.2612 -1.11473 -8.0868 -15.4525 -74 2 7.03744 9.07449 11.5759 -13.2083 9.2101 17.4474 -75 2 6.9295 9.8935 12.9066 11.874 3.71682 2.38348 -76 1 16.2958 12.8923 2.71536 -7.68956 9.05075 5.11912 -77 2 17.1057 13.405 2.60095 0.726983 -7.0699 -1.53932 -78 2 15.5966 13.5689 2.77432 5.93986 -8.84533 -0.161974 -79 1 0.748159 12.7086 5.88144 -10.9756 -4.32923 1.80334 -80 2 1.126 12.5118 5.01571 -4.75041 4.90571 -2.30818 -81 2 18.4243 12.6438 5.75836 11.281 1.67442 1.09101 -82 1 5.27578 16.4085 18.412 4.21131 -11.5608 4.53747 -83 2 5.56823 15.5611 18.0525 -2.79743 5.31701 -3.02359 -84 2 5.61546 16.4141 0.666595 -0.372752 7.00853 0.303479 -85 1 0.645783 7.7249 4.17395 -22.5174 -18.1833 12.2453 -86 2 0.0406635 8.03244 3.50183 -6.8254 3.26088 -7.40309 -87 2 1.47404 8.07846 3.91568 30.354 9.58108 -9.75695 -88 1 3.15689 8.99663 6.46784 -29.6014 22.5811 -11.1032 -89 2 3.73467 8.6187 7.10087 15.4493 -13.4368 20.8179 -90 2 2.24881 8.95158 6.82736 13.2955 -4.68481 -5.71698 -91 1 7.31562 10.4015 16.2316 3.59442 1.76188 5.73087 -92 2 6.55849 10.6763 15.7162 -1.33577 1.2968 -0.922241 -93 2 7.0153 10.388 17.1537 0.717273 -3.98644 -9.35278 -94 1 11.0545 0.930228 4.99952 5.57476 -3.06583 5.10436 -95 2 11.2493 1.80197 4.63341 -8.70362 -0.159614 -5.22362 -96 2 10.8601 0.352804 4.24475 -0.891787 5.80331 3.4075 -97 1 4.31226 2.88036 13.174 -5.147 13.5187 -3.07305 -98 2 4.38813 3.36721 14.0053 4.89736 -4.04185 -0.502489 -99 2 4.16611 1.96327 13.4122 -1.31506 -9.67947 3.52696 -100 1 8.44169 10.2311 1.79631 7.56357 -11.9838 -1.9735 -101 2 8.31668 10.8926 2.47474 -4.45102 7.488 6.50539 -102 2 8.68604 9.43265 2.286 -2.4935 0.872154 -3.30188 -103 1 10.3613 1.71229 15.5051 2.98347 -4.15867 -5.41234 -104 2 11.2858 1.47948 15.6006 4.17674 0.252173 3.54686 -105 2 10.224 1.77346 14.5485 -4.83776 4.02156 4.39256 -106 1 2.62824 12.9587 7.89058 0.896502 -11.3927 -2.22701 -107 2 3.24219 13.4607 7.34422 -0.123332 4.88452 0.659902 -108 2 1.95928 12.6032 7.2874 1.64097 5.4786 -0.796639 -109 1 3.80872 11.636 4.95037 -11.7682 3.18495 22.2339 -110 2 3.64598 10.9456 5.61445 0.836076 6.10931 -6.44063 -111 2 2.95096 11.8687 4.56439 8.15456 -6.07271 -3.548 -112 1 6.68955 14.4669 16.969 -3.81156 3.78561 -6.36768 -113 2 7.31157 15.1356 17.2607 6.01474 -1.04117 -0.64393 -114 2 6.3928 14.7335 16.0851 0.840242 -1.58899 4.15547 -115 1 14.2051 14.5083 3.2908 -7.03725 6.3674 -0.58292 -116 2 13.7783 15.3639 3.15563 1.95336 -1.87129 -0.261548 -117 2 13.7683 14.1355 4.06228 2.52608 -4.66484 0.961916 -118 1 8.56009 18.0702 16.0712 3.20396 -8.67406 4.91505 -119 2 9.14753 17.3445 16.2475 -6.34669 -24.466 3.58587 -120 2 9.1857 0.126611 16.1642 1.87484 33.3672 -8.78222 -121 1 4.70115 1.72624 4.89274 27.4793 -6.96303 -5.48355 -122 2 3.95894 2.26041 5.13304 -17.2548 11.1403 -0.356707 -123 2 5.27782 2.26423 4.3214 -9.62564 -3.87491 4.20048 -124 1 15.0192 12.5587 16.5123 21.7041 14.8698 31.7439 -125 2 14.5985 12.983 17.2917 0.468388 -8.58398 -21.4185 -126 2 14.4797 12.5149 15.7347 -25.1252 4.80555 -9.98379 -127 1 15.7034 18.4851 16.8595 11.2428 14.4774 5.40242 -128 2 16.3726 18.3616 17.5507 -1.30019 6.81093 -3.04699 -129 2 15.2229 17.666 16.8625 -3.30988 -17.6635 -4.60623 -130 1 1.33118 1.27529 16.6047 -9.4861 0.393225 2.74141 -131 2 2.17004 1.71925 16.7831 -4.45817 3.09534 0.768406 -132 2 0.687638 1.66877 17.2201 8.28198 -2.79213 -3.95818 -133 1 18.1871 4.40384 15.9188 -4.2246 -5.6904 -13.4727 -134 2 18.0103 3.84369 15.1415 2.73285 7.2293 11.0268 -135 2 0.486098 4.58175 15.924 0.765927 0.250404 0.0527718 -136 1 12.1931 17.0307 16.1573 -7.03075 -8.39993 15.6705 -137 2 11.4402 16.4961 16.4862 10.3932 12.5123 -4.95214 -138 2 12.1197 17.0939 15.2076 -10.1529 0.179256 -12.7611 -139 1 16.106 2.59107 18.2096 -1.1157 3.6739 1.58184 -140 2 15.8464 3.51014 18.3379 -6.23469 -2.00336 3.76026 -141 2 15.8431 2.36085 17.3192 0.233798 0.882779 -7.24243 -142 1 6.71273 13.8002 10.1277 -4.97427 -8.24119 9.58999 -143 2 6.56779 13.4217 11.0085 1.93353 6.26249 -2.22943 -144 2 6.54815 13.0587 9.53715 2.49444 0.869035 -6.59786 -145 1 10.1873 18.4315 2.70955 18.3562 4.9239 2.5593 -146 2 10.5434 0.318979 1.97838 -6.6136 -2.73616 6.22508 -147 2 9.38189 18.0459 2.39836 -17.7025 -5.54205 -6.95436 -148 1 3.04496 17.7072 6.14474 -26.0897 -13.5421 -17.7616 -149 2 2.15406 17.5302 5.73662 26.1077 6.8467 16.2169 -150 2 3.64192 17.5514 5.40101 1.03601 7.77362 4.67988 -151 1 12.6273 16.8318 7.93854 -11.3452 0.662957 5.12661 -152 2 11.8845 16.2201 7.89678 1.40738 -6.80959 -10.3945 -153 2 12.3926 17.3902 8.68441 7.00662 7.84172 2.34647 -154 1 14.8855 15.2416 8.18261 -13.4645 13.8861 12.0711 -155 2 14.0556 15.7424 8.32689 13.5062 -6.9847 -4.51651 -156 2 15.2561 15.6092 7.37576 4.4997 -5.95581 -2.20609 -157 1 17.7963 18.2323 0.313468 22.8316 -1.73762 -16.8861 -158 2 18.5551 17.7341 -0.0636659 -20.2187 -0.580139 11.9305 -159 2 18.2144 0.43747 0.484185 -10.4644 5.54896 5.21224 -160 1 0.772309 10.5133 1.37975 -10.1333 -30.1062 6.79594 -161 2 0.0813059 9.81759 1.5081 15.2254 18.695 2.54909 -162 2 0.385285 11.1613 0.797203 -0.976125 9.32481 -5.57513 -163 1 1.78018 12.2676 3.33949 2.15539 9.4235 -7.57379 -164 2 1.54035 11.6193 2.6706 -4.1225 -6.27654 2.3776 -165 2 2.05243 13.0385 2.81809 -2.70385 -1.96831 6.56166 -166 1 0.659925 17.2426 4.96586 -18.1386 9.04401 18.0738 -167 2 0.178596 18.0473 5.21064 6.21229 2.02654 -16.1731 -168 2 0.324647 16.6226 5.62628 12.0605 -8.44774 -8.6881 -169 1 1.10032 0.835558 9.36207 -6.74911 6.08386 15.0138 -170 2 1.34007 0.666464 10.2949 -2.02307 -2.81345 -10.1719 -171 2 0.1714 0.592543 9.31025 -1.22709 -3.40717 -2.54195 -172 1 16.7505 2.35163 13.3289 8.60057 15.8485 -12.5846 -173 2 16.88 2.58008 12.3859 -1.48994 0.98841 16.7513 -174 2 16.5792 1.4154 13.3346 -5.94985 -15.1034 2.43107 -175 1 2.68711 15.9094 12.0537 -2.04437 -0.129745 31.1177 -176 2 3.02052 15.4906 12.8711 -6.40464 9.26827 -14.3072 -177 2 3.17282 15.5129 11.3342 0.535683 -2.02659 -8.3952 -178 1 16.4208 15.6182 6.1352 -21.1289 -3.6799 -9.5135 -179 2 17.2955 15.5836 6.51556 8.3115 3.57969 -3.1518 -180 2 16.3537 16.3493 5.49765 5.76519 -7.13598 7.22522 -181 1 5.79664 5.13529 11.8088 -4.38676 10.3557 2.90642 -182 2 5.60006 6.00552 12.2032 -0.739769 -8.67447 -3.0914 -183 2 5.02307 4.59055 11.9941 4.66701 -2.35447 -0.0408817 -184 1 15.1607 4.87263 0.806669 16.5091 -1.57376 7.82361 -185 2 14.8955 4.71033 1.72542 2.63671 -2.24198 -6.9535 -186 2 14.4069 5.23734 0.370441 -15.2288 7.71764 -6.62645 -187 1 16.3977 16.3968 1.96949 3.68196 12.8197 -24.7966 -188 2 15.8359 16.7471 2.65913 3.23547 3.93446 11.4731 -189 2 16.7724 17.1777 1.4991 -6.44753 -16.1278 10.1249 -190 1 0.213933 4.82135 3.88253 -26.808 7.93653 -12.3623 -191 2 0.234051 5.77519 3.99531 2.75938 5.29795 -1.25016 -192 2 0.961943 4.50047 4.34745 23.7428 -13.1307 13.4767 -193 1 2.96019 15.0595 15.1256 -5.74802 5.98414 7.79678 -194 2 2.74143 14.6748 15.982 5.94976 -7.2483 0.528018 -195 2 2.64636 15.9627 15.2549 -2.4967 2.40481 -11.2251 -196 1 1.11613 14.6445 9.47707 24.3082 -3.71628 -27.1602 -197 2 1.83443 14.0608 9.11052 -24.4018 17.7336 11.9542 -198 2 0.662892 14.1245 10.1216 -3.75634 -10.5151 15.6601 -199 1 13.5123 16.5361 11.5209 14.3415 8.92342 18.194 -200 2 13.0624 17.3115 11.1648 -0.833334 -0.722864 -7.66511 -201 2 12.9752 15.7809 11.2867 -3.03575 -6.70349 -11.2125 -202 1 4.68996 1.46706 0.718872 11.9134 2.33738 12.4928 -203 2 4.09477 2.04355 0.241198 -5.36661 3.4607 -5.79099 -204 2 4.1604 0.969338 1.36347 2.85434 0.638429 -14.0321 -205 1 1.49954 18.563 11.8891 -5.50653 18.8512 6.56283 -206 2 1.44134 0.571379 12.6129 -0.0136494 -9.64138 -5.67935 -207 2 2.21117 17.97 12.1221 3.30859 -8.66659 1.78907 -208 1 11.4402 10.1273 4.0296 -14.1313 -2.26429 -1.73879 -209 2 11.5467 10.5306 3.16018 -4.20959 -0.177974 3.37558 -210 2 12.3237 10.0244 4.36159 16.2917 -0.468181 5.60308 -211 1 8.19952 12.1987 3.67367 7.5254 -0.929385 2.30686 -212 2 9.06593 12.5735 3.89529 -5.56433 -0.233543 6.4332 -213 2 7.60827 12.3201 4.43288 5.90715 0.804339 0.890554 -214 1 14.5695 4.00736 3.30806 -0.853883 -3.91237 -3.28064 -215 2 15.2428 4.12216 3.97778 4.83301 -0.192226 6.11595 -216 2 13.7947 4.43075 3.66998 -10.7695 5.18811 0.448659 -217 1 5.68852 1.65707 7.54168 28.123 23.6896 24.0894 -218 2 4.98915 1.23464 8.0079 -23.0977 -17.1785 12.6492 -219 2 5.54722 1.47278 6.63267 -9.12733 -3.0122 -32.3212 -220 1 17.8871 1.01837 4.84182 2.82015 7.71075 0.411156 -221 2 18.4334 1.54735 4.24341 -1.55475 -9.21419 -1.50179 -222 2 17.685 1.60385 5.57556 -2.0638 -1.04483 2.6292 -223 1 6.8166 9.34907 4.51783 5.09473 -9.82493 1.7662 -224 2 6.68916 9.48214 5.46541 0.845655 -0.0829088 -1.52267 -225 2 7.72677 9.02302 4.42297 -5.47106 2.64724 -1.23342 -226 1 2.52902 14.8001 2.0243 -5.93162 -1.84873 -28.2955 -227 2 3.33024 14.7833 2.53171 11.9325 -2.28831 13.4023 -228 2 2.81062 14.7362 1.08886 -6.14041 -0.158095 16.8135 -229 1 17.2862 12.9192 13.1313 -13.4327 18.0081 -1.69868 -230 2 16.3974 13.2513 13.3936 19.5241 -4.39437 -6.93828 -231 2 17.8009 13.724 12.9107 -8.95295 -13.2998 3.51907 -232 1 14.8818 10.557 1.42323 -17.5015 7.25829 9.68839 -233 2 15.2835 11.3752 1.77244 -3.15433 -10.3089 -2.91904 -234 2 13.933 10.5609 1.67153 21.0133 3.93252 -5.34474 -235 1 5.70173 6.62264 4.58284 3.01718 2.50499 1.71703 -236 2 5.75902 7.56019 4.39794 2.55817 9.91828 -0.0203224 -237 2 6.42399 6.43452 5.20085 -6.85011 -4.70646 -2.52597 -238 1 8.0341 8.36204 10.3892 10.4405 -6.77488 -14.8808 -239 2 8.6296 8.90948 9.85447 -2.74542 2.30932 7.48232 -240 2 7.64772 7.74454 9.75603 -3.95063 2.60786 3.00172 -241 1 13.4272 18.4528 5.67238 9.25795 -5.11499 9.49722 -242 2 12.7163 0.440246 5.56173 -10.019 1.98309 -6.96611 -243 2 13.1619 17.9514 6.45613 2.7128 -4.57063 -2.8 -244 1 -0.0270522 2.62208 0.316378 14.2494 -14.2567 4.73545 -245 2 17.7181 2.78355 18.7164 -19.3625 -8.86024 -5.69671 -246 2 0.361548 3.46719 0.160861 21.2807 17.6319 0.792983 -247 1 12.9304 10.9756 9.73287 -28.9199 -18.5822 3.85047 -248 2 11.9453 10.9259 9.78333 22.7984 8.3459 -7.73181 -249 2 13.1639 10.0723 9.99967 2.00349 4.19966 -2.07729 -250 1 0.632704 12.1509 11.1096 7.92792 10.2243 1.08862 -251 2 18.3238 12.1837 11.2671 1.30826 1.36738 8.17016 -252 2 1.12128 12.4175 11.9061 -11.5401 0.628467 -1.63311 -253 1 5.16172 7.34292 13.3779 5.89076 -0.786387 1.26512 -254 2 5.63913 8.13751 13.0818 -0.253704 -8.62988 -1.18816 -255 2 5.64992 7.00871 14.1461 -2.49218 7.71701 -3.25354 -256 1 1.18315 6.80996 11.9457 -21.1971 9.90527 -11.1777 -257 2 0.396163 7.2181 11.5121 19.4256 -12.5543 10.5539 -258 2 1.74685 7.55572 12.1675 3.51989 2.12142 1.71712 -259 1 15.5171 9.71047 12.3281 2.29457 -6.5479 -4.23973 -260 2 15.3017 10.6102 12.0519 -2.15799 -4.39765 10.01 -261 2 15.6816 9.70968 13.2745 -0.591496 3.33032 -0.321137 -262 1 16.5873 12.6729 5.56721 2.76163 -0.166181 -5.31991 -263 2 16.3773 13.5773 5.84608 0.225425 -0.965456 -7.72797 -264 2 16.4542 12.6253 4.60029 -0.729256 4.09093 10.083 -265 1 6.36605 9.79142 0.024922 -16.0501 18.8211 -0.426432 -266 2 5.53971 10.2677 0.213525 8.17613 -4.10964 1.60097 -267 2 6.98218 10.0336 0.714657 7.30358 2.91784 7.9977 -268 1 12.2857 6.09281 4.02237 -18.7873 -18.2554 10.8389 -269 2 12.2499 6.90248 3.51498 -0.180994 1.77121 -11.4426 -270 2 11.3769 5.71462 3.99073 18.6718 6.8659 -0.0124277 -271 1 0.371339 12.8581 0.116813 -11.2914 -0.881026 -5.3546 -272 2 18.6979 13.4634 0.798717 1.88955 0.580482 0.906428 -273 2 18.4407 13.0157 17.9982 0.051521 1.66817 1.81741 -274 1 3.57562 18.6672 8.63597 16.8652 -4.29809 -8.00937 -275 2 3.39672 18.3023 7.75382 0.438355 1.17547 6.33464 -276 2 2.72388 0.290377 8.97499 -6.05452 1.31479 -1.62581 -277 1 7.38199 17.3678 4.46374 -1.38292 15.3105 6.33947 -278 2 7.69148 18.255 4.75287 -6.89683 -17.7129 -9.79531 -279 2 7.51455 17.3077 3.50947 0.595015 4.11355 1.7546 -280 1 9.26329 17.1448 12.185 -8.64248 6.96454 5.63337 -281 2 9.31183 16.2501 11.845 1.80177 -5.78684 -3.53436 -282 2 9.93599 17.2354 12.8685 5.43729 -1.39148 -3.55242 -283 1 13.2821 13.1028 8.02698 11.8692 -15.3168 6.16039 -284 2 13.4688 12.3189 8.5813 -8.97739 12.1367 -7.14337 -285 2 14.105 13.618 8.04076 -8.38267 2.98351 0.0644509 -286 1 14.8025 2.98142 15.4294 17.4288 1.80056 -2.61073 -287 2 14.201 2.26032 15.2834 -13.2348 -7.60023 -2.35086 -288 2 15.3302 3.01554 14.6169 0.118996 0.402428 5.45631 -289 1 9.92493 15.6251 16.9821 6.00495 -5.53666 -0.13681 -290 2 10.4191 14.8506 16.6821 -3.27256 -3.64184 -5.012 -291 2 9.59076 15.3546 17.8439 -3.58917 5.2502 2.724 -292 1 11.2797 8.49868 16.6198 -1.73472 -6.52809 -3.79184 -293 2 10.75 7.88393 16.0952 -2.42874 5.03231 0.808132 -294 2 11.4092 8.05007 17.4587 2.82097 -1.86681 0.519814 -295 1 4.04678 18.2455 16.7988 -8.77416 25.1666 -6.65304 -296 2 4.65779 17.694 17.284 2.06605 -2.99109 10.2548 -297 2 3.96053 0.454509 17.276 5.60906 -19.8799 -5.16878 -298 1 2.27095 4.25175 8.91936 5.9784 -6.58712 9.82608 -299 2 3.2186 4.2524 8.72216 -4.79336 -1.38402 1.94738 -300 2 2.18112 3.96584 9.85003 1.09756 8.39619 -11.3917 -301 1 9.88624 10.3936 9.78011 6.22166 -2.86793 -13.7384 -302 2 9.62293 11.2772 9.51568 -5.75811 3.67729 -6.27375 -303 2 10.0642 10.4241 10.7104 0.548842 -0.969577 22.0405 -304 1 9.71663 0.937962 10.8586 -0.709221 -7.70358 -11.4846 -305 2 9.30987 0.134657 11.1937 5.18354 -4.14977 6.17978 -306 2 9.11908 1.1943 10.1452 4.37988 8.3302 1.85952 -307 1 9.18198 15.0956 10.1953 -4.26962 6.22766 7.58802 -308 2 8.89777 15.9846 9.95951 0.743088 2.4445 -7.53567 -309 2 8.34997 14.6032 10.2066 5.52748 -3.88041 -1.79992 -310 1 0.872205 9.70338 10.2435 26.5305 -15.7209 -40.6294 -311 2 0.885793 10.5746 10.6186 -2.04601 10.7115 5.01116 -312 2 1.5471 9.74995 9.50099 -28.1395 -6.59839 33.8889 -313 1 17.1072 4.85649 8.10795 10.9462 -15.5033 5.93553 -314 2 16.3968 5.45295 8.31142 -11.4282 10.1371 2.96807 -315 2 17.1775 4.27052 8.87929 1.82351 6.10377 -11.9311 -316 1 14.794 14.6968 0.0807509 -15.0506 -16.2211 -7.1198 -317 2 15.1293 15.3316 0.707575 7.57499 5.98458 11.2724 -318 2 13.942 14.3729 0.412504 5.92115 1.12787 4.02247 -319 1 3.8058 11.0463 9.54758 -4.72716 5.89465 -11.0149 -320 2 3.75265 11.4758 10.4012 1.08641 -1.46789 11.7249 -321 2 3.34125 11.6425 8.94232 1.4747 0.62014 0.836248 -322 1 11.3036 10.7395 1.51518 17.421 7.70001 -9.9965 -323 2 11.5572 11.5513 1.04939 0.916953 -2.49636 4.28379 -324 2 10.3663 10.6689 1.38091 -17.6315 -2.91035 -1.9437 -325 1 13.1498 7.19173 12.6392 -12.6781 -12.1868 5.62798 -326 2 14.0645 6.9093 12.7169 6.63809 2.55694 -2.55252 -327 2 12.6264 6.38473 12.8035 6.43409 8.48166 -2.8301 -328 1 9.6244 1.91603 0.948782 1.73007 4.87205 -17.2591 -329 2 8.78103 1.84907 0.47922 2.387 -4.26061 4.8929 -330 2 10.2561 2.20979 0.275304 -2.56753 1.91417 5.98087 -331 1 10.6541 13.4625 4.53479 -4.64228 5.78216 2.02785 -332 2 11.5543 13.1406 4.67483 -3.60366 -2.8444 3.58336 -333 2 10.4931 14.1115 5.23949 3.28752 -7.90473 -1.94244 -334 1 14.4847 1.66582 10.9548 -5.6847 9.24739 -2.41061 -335 2 15.2495 1.25185 10.5509 3.51804 0.734089 -1.48015 -336 2 14.6665 2.62215 10.9157 -2.44239 -9.64589 2.94827 -337 1 14.5153 12.0551 11.6598 -8.57838 4.331 1.02894 -338 2 15.2406 12.4341 11.1775 15.6624 8.75252 -5.54666 -339 2 13.8905 11.8145 10.9694 -5.00706 -1.53612 2.9308 -340 1 8.18805 5.09916 9.82303 -13.8101 6.02591 4.86356 -341 2 7.31243 5.14562 10.2589 14.5937 -0.354252 -5.27398 -342 2 8.2462 4.20505 9.47267 -0.0530366 -3.80538 1.315 -343 1 1.47125 16.9173 18.4665 17.3664 16.657 -21.1079 -344 2 1.9236 17.2269 17.6455 -9.65792 -6.20403 18.6505 -345 2 1.59593 15.9726 18.4726 0.464255 -9.97504 -1.82966 -346 1 1.48039 17.3287 15.3228 1.51401 14.0556 6.72393 -347 2 1.34693 18.2292 15.6575 8.56134 -5.76509 -0.66881 -348 2 0.596093 16.984 15.2507 -11.2139 -7.77617 -1.25224 -349 1 3.58273 5.77174 6.05172 -7.98503 -18.1926 7.56457 -350 2 3.04578 6.35459 6.60151 3.24577 3.33226 -0.333817 -351 2 4.18271 6.30655 5.53303 2.15541 4.89174 -3.71227 -352 1 12.4965 9.48476 14.2165 -0.670713 16.0192 -6.73881 -353 2 12.9556 8.76438 13.7775 2.07937 -6.9932 3.10842 -354 2 12.3436 9.22115 15.1264 1.05397 -7.72063 3.19376 -355 1 4.0654 15.2599 7.01126 14.536 -9.99762 3.77636 -356 2 3.57418 16.0458 6.77165 -4.77502 7.81332 -2.1228 -357 2 5.00035 15.4681 6.83264 -6.89866 -1.23873 3.67355 -358 1 0.723833 8.69198 15.0851 1.39297 0.947643 -5.33928 -359 2 0.438801 9.60781 15.1421 -2.06214 4.43911 1.45744 -360 2 1.38458 8.70272 14.3802 0.858615 -3.42768 2.38717 -361 1 12.8756 8.29184 10.1606 18.5084 -5.85873 3.08502 -362 2 13.7209 7.89345 9.85142 -16.8549 4.13316 8.30657 -363 2 12.7515 7.97965 11.0724 6.23426 1.04322 -7.42686 -364 1 15.3229 7.8277 3.50947 17.5558 22.7432 -34.5468 -365 2 14.4697 7.71438 3.07339 -7.31906 -8.87793 15.8657 -366 2 15.4806 7.65388 4.43399 -18.8005 -15.0751 11.2523 -367 1 17.2596 6.73529 0.0260639 -2.34928 8.60384 0.474092 -368 2 16.7705 6.01921 0.434638 -6.55856 -4.92879 -0.567585 -369 2 16.5991 7.41683 18.4475 3.41319 -8.53114 -0.808778 -370 1 8.95463 6.95692 7.78734 -12.7059 -4.64784 9.91199 -371 2 9.87027 7.23168 7.81087 8.51327 4.71948 -0.0600656 -372 2 8.83651 6.35153 8.53608 0.68522 0.961995 -1.89804 -373 1 12.4059 0.607414 1.26231 3.62116 2.02707 -9.0712 -374 2 13.2571 1.01103 1.48145 3.02509 -6.80244 -1.55076 -375 2 12.4394 0.42011 0.312768 1.30302 -0.072107 7.45087 -376 1 5.61221 15.1181 14.5069 21.81 1.56396 -5.03583 -377 2 4.69671 15.2613 14.7447 -7.9418 2.21424 1.99916 -378 2 6.02853 15.9808 14.3125 -8.14435 -8.16553 0.0834836 -379 1 3.81616 6.42663 1.71897 -4.74342 3.6354 -4.79161 -380 2 3.34042 7.16969 1.31421 3.65203 2.80462 3.7212 -381 2 3.89499 6.64183 2.65143 -2.11765 2.44111 2.19083 -382 1 3.90516 11.4598 12.3793 9.45586 -8.94044 -12.3546 -383 2 4.79548 11.8227 12.4942 -7.15738 -0.735807 -0.876075 -384 2 3.31554 12.0782 12.7961 -9.4854 7.67777 7.65311 -385 1 5.30665 3.87758 15.8091 -6.5654 14.2288 -0.0449474 -386 2 5.99806 3.22942 15.6938 11.0923 -7.17561 -6.6845 -387 2 5.74209 4.7421 15.8325 -0.91092 -4.98763 -0.535492 -388 1 14.1952 10.2038 4.61463 -6.5923 1.74463 -22.8561 -389 2 14.2343 9.86507 5.49824 4.23866 -7.49318 19.2708 -390 2 14.5963 9.53108 4.04607 2.17028 4.66107 2.75401 -391 1 7.63145 17.3499 9.0679 -5.43123 5.71002 -0.0698024 -392 2 6.89643 17.6949 9.58041 -2.21022 -5.88459 7.45639 -393 2 7.83827 18.0718 8.46746 8.40651 -1.69566 -7.5742 -394 1 4.52514 14.4769 3.85867 5.05038 7.53463 5.39007 -395 2 4.64261 15.388 4.18066 -3.91408 -9.29834 -6.31781 -396 2 4.46355 13.9264 4.6465 1.7827 -2.93555 -2.6265 -397 1 14.2493 7.38723 15.8586 4.87219 -5.15553 -0.709446 -398 2 15.1473 7.29965 15.5014 -5.21416 1.68161 3.76194 -399 2 14.3665 7.7773 16.7353 0.544226 -0.39761 -4.2243 -400 1 3.0581 18.4144 1.95119 -22.1859 -8.41359 7.65322 -401 2 2.57832 17.7386 1.43356 3.30075 12.2585 2.4632 -402 2 2.38613 0.281938 2.45339 8.18993 -10.3808 -10.0068 -403 1 7.97435 1.63455 4.58282 23.9975 -9.20271 -17.826 -404 2 7.40194 1.94347 3.87976 -9.32013 4.13397 -1.27928 -405 2 8.80392 1.4125 4.10448 -12.4762 5.5818 15.8983 -406 1 2.4378 14.1623 17.6894 -3.94912 5.20331 -2.53114 -407 2 1.6661 13.615 17.8755 3.58117 1.8004 4.78536 -408 2 3.18519 13.6404 17.9779 13.28 -5.73443 1.82606 -409 1 0.901685 1.86492 13.8925 12.6905 0.691236 2.76957 -410 2 0.97461 1.67681 14.8348 2.02403 -0.73996 0.457614 -411 2 -0.0244921 1.99897 13.7259 -14.1961 2.08272 -4.4518 -412 1 4.37872 0.0904002 13.8777 13.1739 1.11326 -7.50903 -413 2 5.30332 18.4699 13.7308 -6.52685 1.52196 1.48666 -414 2 4.22979 18.5754 14.8098 -5.10379 -2.3914 9.04502 -415 1 7.27651 0.845893 18.3957 -16.6762 17.2151 26.568 -416 2 7.1678 0.492927 17.521 -0.448362 -6.22938 -12.6047 -417 2 6.39207 1.1517 18.718 17.8505 -10.612 -11.3067 -418 1 15.9607 18.375 13.9642 -35.6371 5.35013 -16.5011 -419 2 15.0008 18.4642 13.7578 26.2499 -2.51915 -0.30366 -420 2 16.0214 0.00880953 14.871 6.50934 -2.46523 19.0717 -421 1 10.2176 4.60873 16.2514 5.45645 -16.296 -9.2455 -422 2 11.1834 4.4434 16.3559 -20.4013 6.80033 -5.0518 -423 2 9.84346 3.80184 15.8357 11.7075 10.859 12.3241 -424 1 15.9288 17.6854 4.49702 -25.8895 1.84686 -2.2825 -425 2 16.5611 18.3979 4.49336 8.57016 10.0602 -1.14853 -426 2 15.0697 18.092 4.72548 12.7214 -6.58434 0.45321 -427 1 6.97646 17.4765 13.8835 1.51347 6.32825 6.74987 -428 2 7.46829 17.7625 14.676 -2.92413 -3.08896 -9.25103 -429 2 7.63479 17.4162 13.1781 -0.793447 -1.23312 2.0982 -430 1 13.2369 6.46193 6.55272 7.97686 -7.07829 -14.9633 -431 2 14.2045 6.47863 6.50403 -7.11621 7.88379 2.07663 -432 2 12.9571 6.40302 5.61769 -2.27464 -2.27743 14.9713 -433 1 7.84752 2.28013 9.41028 -8.73892 -0.731414 -17.5278 -434 2 7.29261 2.26329 10.1936 -2.39479 -1.12016 7.77392 -435 2 7.27021 1.99883 8.67538 7.42107 2.89864 6.55304 -436 1 15.163 14.8378 13.7075 -5.08255 6.9114 -1.94911 -437 2 14.828 14.9803 14.5966 0.517852 0.790599 5.03408 -438 2 14.8205 15.5736 13.1818 1.46712 -6.90646 -0.613497 -439 1 9.40195 8.33905 3.81803 -16.6236 -1.1153 -3.723 -440 2 10.1861 8.88666 3.81624 11.7714 1.21262 5.85608 -441 2 9.65895 7.42947 4.01423 -0.646232 2.08147 -2.76231 -442 1 17.7496 13.6056 16.4496 1.61536 7.2683 -6.30775 -443 2 16.7925 13.5164 16.4445 -3.33508 -5.74033 1.31806 -444 2 17.9176 14.3949 15.9026 -1.24178 -7.25826 8.29135 -445 1 4.89231 10.51 2.8606 23.2586 -26.6571 -20.5821 -446 2 5.63741 10.0083 3.24852 -7.78968 12.4235 -4.83768 -447 2 4.54582 11.03 3.56787 -4.03679 11.8248 12.8852 -448 1 3.69823 8.4002 10.0127 -3.60192 -11.2793 13.5005 -449 2 3.83759 9.3113 9.76164 0.279778 8.83932 -1.11316 -450 2 3.64192 8.42085 10.9836 -1.53751 -1.28356 -9.75822 -451 1 15.9467 6.92332 5.94112 11.8737 -8.24502 3.37919 -452 2 16.7476 7.39494 6.19571 -0.497479 1.69122 3.51528 -453 2 16.2467 6.02535 5.70675 -5.68891 13.7396 -0.851978 -454 1 15.1658 7.18492 9.0507 -10.4703 -15.8706 0.47552 -455 2 15.9236 7.59272 9.46168 11.862 8.93317 3.67812 -456 2 14.9906 7.60382 8.20629 4.02444 8.70872 -4.23998 -457 1 6.21618 12.8841 12.7284 -3.21766 12.2709 11.5322 -458 2 6.77909 12.207 13.0973 14.7659 -5.65099 1.01901 -459 2 6.15827 13.5741 13.4151 -3.2657 -3.93324 -9.28774 -460 1 12.1165 4.51288 13.1048 -1.62418 -0.0716723 20.7898 -461 2 12.3817 4.58382 14.0419 2.18295 3.85449 -11.1604 -462 2 11.2475 4.10019 13.1569 -0.321339 -3.45694 -9.73345 -463 1 11.4166 8.11249 7.92599 8.37678 -3.86112 -10.8327 -464 2 12.0468 7.60844 7.37796 -5.38848 4.21425 7.2331 -465 2 11.8428 8.18692 8.79136 -5.59584 -0.0130509 -4.24997 -466 1 17.091 10.8655 7.57222 -5.5019 -10.6926 10.9756 -467 2 17.8562 10.3128 7.37833 -2.02493 -0.998523 -7.2616 -468 2 16.8515 11.3839 6.80089 6.08197 4.8342 -8.48749 -469 1 5.2937 18.1227 10.8823 3.58086 -4.72457 -4.80722 -470 2 4.89277 17.7527 11.67 -2.28546 -3.10604 1.32943 -471 2 4.67512 17.9479 10.167 -5.31481 4.288 -3.34371 -472 1 7.59808 17.4966 1.71058 0.398559 1.64094 13.9409 -473 2 7.8828 16.705 1.25288 5.11743 -4.18927 -7.63945 -474 2 7.62118 18.2252 1.08608 -3.03358 1.0728 -8.8916 -475 1 1.91712 12.8862 13.5909 8.98798 9.32187 -3.03347 -476 2 1.48166 12.3531 14.2581 -2.09819 -2.06604 3.51643 -477 2 2.30811 13.6552 14.041 -7.16378 -5.11315 -1.13098 -478 1 9.42828 6.75322 14.7826 20.1915 -11.5504 -11.1057 -479 2 9.8277 5.94835 15.1588 -6.88663 6.02054 3.69259 -480 2 9.80073 6.79406 13.8821 -8.1098 8.28496 9.35183 -481 1 15.2968 4.25709 10.7854 2.83104 8.23395 -4.89519 -482 2 16.2313 4.08269 10.6128 -5.94582 -2.20316 7.08238 -483 2 15.3124 5.02999 11.3646 -3.5924 -3.42311 1.83328 -484 1 11.2927 6.22318 0.123361 12.5475 12.622 0.859144 -485 2 11.5233 5.29113 18.7512 -7.74436 -5.44097 -5.24926 -486 2 10.3808 6.34995 18.4806 -0.327163 -9.85792 5.03233 -487 1 18.5472 11.423 14.9732 18.3726 -20.3084 16.0571 -488 2 18.105 11.7915 14.2257 -13.2839 12.4126 -20.1368 -489 2 18.4564 12.0929 15.6514 -4.79118 8.10765 5.85542 -490 1 7.00881 9.27577 7.32015 -11.3868 -9.38104 -0.512081 -491 2 6.68278 8.41602 7.64312 1.53223 10.0212 -0.264373 -492 2 7.94615 9.16913 7.19167 13.4366 -2.83724 0.374421 -493 1 18.3388 15.3149 12.278 7.79295 4.11927 0.907342 -494 2 0.562248 15.7272 12.1255 -3.32497 -4.13752 -3.12696 -495 2 17.7171 15.7348 11.6722 2.18188 4.14775 -1.5511 -496 1 16.4968 4.40066 5.28798 -9.94208 -5.06851 -0.773295 -497 2 16.7853 4.2225 6.18546 2.9967 -3.39819 7.99443 -498 2 17.2662 4.33461 4.72457 15.1936 4.75592 -3.34352 -499 1 17.7173 3.18772 10.7866 10.4448 7.42964 -1.18609 -500 2 18.6422 3.37989 10.9855 -1.52891 3.674 4.44234 -501 2 17.7488 2.39891 10.2588 -4.04978 -15.6839 -7.32077 -502 1 12.3149 18.6145 10.0881 -2.22129 4.11252 3.54852 -503 2 11.4444 0.333084 10.2939 -3.02626 -1.86973 1.00626 -504 2 12.9201 0.705852 10.2372 4.71846 0.03299 -1.96706 -505 1 10.3684 9.76179 12.4758 17.9734 4.74974 2.50525 -506 2 11.1916 9.84607 12.9926 -11.8304 0.187235 -1.96375 -507 2 10.3012 8.81681 12.3218 -3.77483 -3.01576 0.0814472 -508 1 0.689392 2.74058 7.08104 -5.98449 10.1616 9.8561 -509 2 0.88859 3.44563 7.72485 0.581102 -9.26818 -8.93017 -510 2 0.974446 1.93578 7.5088 2.3916 -6.77547 7.05728 -511 1 0.277472 15.3259 6.84135 0.228059 -1.31559 -11.5462 -512 2 0.516029 15.5821 7.71821 6.50181 -1.47438 23.8891 -513 2 0.58839 14.4222 6.74639 0.679055 -1.95969 -5.2972 -514 1 17.0529 6.97528 15.0633 10.9144 -7.53558 1.72506 -515 2 17.8201 7.55974 14.9678 -6.11827 1.26888 -1.51964 -516 2 17.4266 6.16431 15.4413 -5.39729 2.11926 -0.659196 -517 1 9.11957 12.4732 8.03484 -32.1356 7.88594 4.6652 -518 2 9.41535 11.8783 7.35952 15.5672 -13.5118 -9.19924 -519 2 8.15954 12.512 7.86156 14.5216 4.72308 9.92056 -520 1 1.18275 1.7303 2.88012 3.13258 6.74516 -6.07855 -521 2 0.990874 2.23802 2.08159 -8.2151 -5.8717 0.0306137 -522 2 1.74436 2.31191 3.39299 4.34337 2.29394 9.11202 -523 1 4.11863 15.0886 9.98721 11.0177 -1.77256 -13.134 -524 2 4.02022 15.2012 9.03136 -3.58336 0.815549 3.23991 -525 2 5.04995 14.8741 10.1041 0.462863 -2.8957 0.615957 -526 1 7.38268 2.21023 14.7219 2.37064 11.9314 4.06902 -527 2 7.04717 1.62795 14.04 0.302375 -0.796384 -5.36483 -528 2 7.78873 2.97247 14.2654 -8.69617 -12.215 6.09363 -529 1 18.4343 14.5687 2.16054 8.35658 -0.618946 0.782777 -530 2 0.682906 14.919 2.34098 -12.2336 -1.59186 -0.620803 -531 2 17.7977 15.2902 2.22089 3.32879 4.73949 -0.959115 -532 1 10.0087 2.72001 12.9057 2.08485 -1.52945 -12.9938 -533 2 10.0412 2.17732 12.096 -1.38389 3.39971 12.264 -534 2 9.25575 3.30628 12.7713 -2.15732 -0.406341 3.704 -535 1 2.9831 8.88024 13.0189 0.952466 11.8173 -3.08609 -536 2 3.31938 9.77893 12.8076 -5.04245 -14.2298 4.61688 -537 2 3.71596 8.41411 13.4449 -4.1112 -0.429279 -5.2011 -538 1 3.20203 8.5912 3.76846 -11.4045 -12.6583 26.9753 -539 2 3.76961 9.22975 3.3591 6.50161 14.1888 -13.0281 -540 2 3.15464 8.85629 4.71231 4.40411 -9.17072 -19.7321 -541 1 5.64764 7.22249 8.60582 -2.45044 -0.628932 2.27153 -542 2 5.55364 6.27099 8.49955 3.15339 -1.29251 -2.67256 -543 2 4.90409 7.47651 9.17344 9.24373 2.45699 -1.73114 -544 1 14.907 1.53023 1.85078 -7.37767 -15.1485 8.29721 -545 2 14.668 2.24872 2.45072 11.5035 7.56218 -5.89301 -546 2 15.6059 1.77377 1.2289 -9.91057 9.46649 1.95684 -547 1 8.55561 15.0845 0.759561 -2.78586 4.97755 1.3099 -548 2 9.2232 15.1059 1.46635 -5.75771 -3.12613 -8.68727 -549 2 7.79979 14.5909 1.11068 3.03755 -1.08449 1.22088 -550 1 15.5064 1.39564 7.20176 -2.04619 -6.07348 -4.735 -551 2 14.846 0.870461 6.73047 4.3658 -0.949999 1.00211 -552 2 15.0733 2.23713 7.35024 -3.19526 7.79987 5.63196 -553 1 4.99693 12.9582 18.4618 -8.43591 -3.95032 12.7964 -554 2 5.427 12.9558 0.691187 -3.21166 1.68806 -6.66553 -555 2 5.5701 13.4759 17.8974 6.4766 -1.03013 -3.5001 -556 1 15.3823 8.61159 18.0651 4.42877 2.22092 -6.07372 -557 2 15.8154 9.23321 17.4587 -2.51695 -7.00562 1.90652 -558 2 15.1591 9.14089 0.186524 -1.03798 5.78876 7.10622 -559 1 12.0334 3.10844 18.3299 11.3082 -20.8993 7.10454 -560 2 12.3341 2.61645 0.471712 -7.66483 12.171 -5.21514 -561 2 12.3614 2.54753 17.6085 -4.58122 9.25845 0.807451 -562 1 13.192 12.7001 5.16537 5.21593 -6.7049 -2.26257 -563 2 13.6127 11.9331 4.74049 -3.39065 6.67562 5.25333 -564 2 13.2679 12.5364 6.11315 0.126366 6.17512 0.133491 -565 1 6.11282 7.21918 0.158665 1.88014 -14.5403 11.0752 -566 2 6.12514 8.17662 18.815 -2.86446 -0.617519 -0.818148 -567 2 5.41227 6.95692 0.781338 0.907384 -1.18964 -10.3034 -568 1 17.7111 15.8907 14.9544 -3.82577 1.28333 3.96962 -569 2 16.7386 15.9987 14.9233 18.3395 -0.0507343 -6.61585 -570 2 18.0408 15.7242 14.0577 -12.1828 1.42979 -0.226855 -571 1 13.1366 0.926204 16.6604 -4.9212 9.87611 -1.92759 -572 2 14.096 0.89187 16.7156 4.29984 -5.34206 5.94224 -573 2 12.8563 0.0335376 16.4436 -2.56348 -3.63873 3.02874 -574 1 10.9184 14.5253 7.38829 1.38398 -2.03118 7.00079 -575 2 10.1136 14.2278 7.85844 13.304 -1.52714 -8.95405 -576 2 11.6006 13.8396 7.51991 -9.17062 7.88742 -1.04716 -577 1 17.6363 8.46247 2.12178 -2.04395 4.31685 9.18728 -578 2 16.787 8.41765 2.58806 4.70486 1.56362 -5.63911 -579 2 17.6123 7.75928 1.47082 0.631216 -3.65047 -4.17578 -580 1 12.4375 7.79355 2.00637 -2.34281 23.5579 2.73553 -581 2 11.9501 8.63365 1.95534 8.51098 -6.49732 1.55884 -582 2 12.0343 7.24559 1.33225 -2.11395 -7.52965 -2.88654 -583 1 12.0451 14.5968 10.4885 2.58602 -10.5702 -25.2135 -584 2 12.3016 14.3716 9.56719 -0.183055 2.34539 21.1217 -585 2 11.1058 14.7694 10.4266 -10.5567 0.791778 1.58055 -586 1 6.78603 6.87835 15.4866 -3.36028 4.68136 22.1121 -587 2 7.71026 7.02894 15.2668 2.14313 -2.1467 -3.22881 -588 2 6.63472 7.41247 16.2893 -0.664868 -8.24615 -12.946 -589 1 7.99755 4.5041 13.3499 24.8278 34.1767 5.68201 -590 2 7.17338 4.66838 12.8997 -9.34484 -1.26894 -9.57598 -591 2 8.42297 5.40326 13.4231 -14.2483 -32.2403 1.51042 -592 1 13.3614 12.2059 14.3726 -2.68828 -3.01756 -2.25781 -593 2 13.124 11.2722 14.2967 -0.0467593 -0.437755 2.8377 -594 2 13.7081 12.4264 13.5024 2.10157 3.54991 -1.69903 -595 1 14.5654 9.5448 7.2719 7.4337 1.87458 1.84958 -596 2 15.4192 9.97446 7.42049 -0.421966 -1.69006 0.109976 -597 2 13.9603 9.96019 7.88547 -6.00597 1.06642 2.40823 -598 1 12.7021 16.8399 3.28406 2.1329 2.22559 -4.89416 -599 2 12.9627 17.2776 4.09814 -1.16793 0.633127 5.57798 -600 2 12.5029 17.5595 2.67417 -2.21511 -1.15635 -1.62469 -601 1 1.01088 7.06774 17.3689 20.0897 -7.47151 2.1243 -602 2 0.171968 6.83932 17.7636 -13.4375 4.7826 3.09836 -603 2 0.861358 7.69882 16.662 -3.49993 1.38105 -6.69635 -604 1 12.9265 4.90969 15.692 -1.72339 7.7777 5.20839 -605 2 13.7461 4.44088 15.8455 2.50132 -9.36464 -4.69309 -606 2 13.1831 5.83499 15.7716 0.254864 4.72294 -0.0726576 -607 1 2.3277 3.38915 5.11911 5.08689 -5.27649 -8.37414 -608 2 1.81648 3.03652 5.84872 -5.99705 -1.71944 1.12123 -609 2 2.79757 4.13118 5.49603 6.03185 12.6803 -1.33855 -610 1 8.22299 10.983 13.6596 -2.68868 6.78672 22.55 -611 2 8.37046 10.9349 14.6227 -7.71168 -0.54916 -12.6902 -612 2 9.06889 10.7219 13.2955 2.07822 -5.6604 -8.58071 -613 1 12.9566 1.54883 13.2404 -6.45532 19.0424 -4.61407 -614 2 13.4436 1.59622 12.409 4.66376 -6.5769 4.30334 -615 2 12.5511 2.44176 13.2892 3.97521 -19.3883 2.5587 -616 1 6.59697 13.6382 2.12308 -19.53 14.6785 -2.92569 -617 2 5.9569 13.9305 2.80289 7.92829 -3.31956 -9.9577 -618 2 7.23585 13.1086 2.59101 5.128 -6.56439 5.02766 -619 1 15.8657 6.47234 12.6041 4.99369 -6.06314 4.28807 -620 2 16.4551 6.98041 12.0348 -2.62867 1.80518 0.0955392 -621 2 16.3109 6.45259 13.4696 -4.62358 3.40022 -7.66147 -622 1 16.7868 0.706192 9.5524 8.10763 10.4692 12.0206 -623 2 16.4993 18.5236 9.95191 3.55616 -11.3811 -4.24312 -624 2 16.3059 0.843102 8.73445 -6.13335 -2.9453 -10.1224 -625 1 6.15553 11.6636 8.28166 8.04937 9.43191 -5.2183 -626 2 5.38812 11.3133 8.7152 -15.4132 0.789816 9.90132 -627 2 6.60546 10.8728 7.99206 7.62403 -6.5238 -2.76924 -628 1 2.80481 8.67956 0.357522 -16.6853 -5.97365 -15.2844 -629 2 2.27492 8.26466 18.2845 10.7138 4.85897 15.9492 -630 2 2.22127 9.36062 0.722932 4.52332 -2.29686 2.25001 -631 1 10.1103 10.3863 6.60128 -6.60242 -1.42487 -6.12592 -632 2 10.6136 9.70804 7.05871 2.40377 -4.05953 3.76861 -633 2 10.2954 10.2785 5.66001 4.13032 2.32994 2.59513 -634 1 6.85077 15.7563 6.70738 -11.7521 -4.07497 3.77538 -635 2 6.99262 16.2462 7.53077 3.71638 -1.24183 -4.26209 -636 2 6.92978 16.3894 5.98454 6.68147 0.141382 -0.214337 -637 1 6.48958 12.9529 5.78988 1.80967 -1.32299 -1.48619 -638 2 6.5811 13.8382 6.15183 4.24501 4.33378 1.70513 -639 2 6.11675 12.413 6.49523 0.159424 2.05888 1.44919 -640 1 16.7629 12.5191 9.71336 -1.62109 -11.3708 1.97787 -641 2 17.0324 11.8284 9.09183 -7.38478 2.50021 2.06117 -642 2 17.4395 13.1763 9.61316 3.98731 12.5093 -0.628579 -643 1 6.20997 2.89816 2.77935 -0.0802363 -5.63791 0.773513 -644 2 6.61167 3.74714 2.54082 -9.15989 -2.58724 -3.98308 -645 2 5.63039 2.60429 2.05445 8.60419 4.25286 3.07741 -646 1 10.7636 3.09526 3.23748 -2.12809 -1.19847 1.63085 -647 2 10.0581 3.70038 3.49376 4.9418 2.80865 -0.749542 -648 2 10.4122 2.60071 2.48751 -0.504171 1.44253 0.108713 -ITEM: TIMESTEP -80 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.8014 6.74321 17.9894 -25.71 0.163943 4.88408 -2 2 7.93592 6.85831 18.4426 18.3019 -2.2716 -9.29 -3 2 8.62145 6.12739 17.2721 4.06901 -0.284928 0.869098 -4 1 0.193099 8.36013 6.75275 5.74913 -14.5769 25.1987 -5 2 0.349094 8.05034 5.86501 -0.249861 0.708817 -17.2091 -6 2 0.558161 7.64099 7.32168 -7.5605 18.9357 -7.69302 -7 1 8.61156 0.29086 6.89037 18.8351 -6.84677 1.91716 -8 2 9.54524 0.192133 6.6105 -17.2936 6.40231 3.46958 -9 2 8.24205 0.986486 6.33979 -0.485036 0.67975 -2.4356 -10 1 6.46061 1.74084 11.7563 18.0716 -9.05138 -10.6926 -11 2 5.90902 2.36746 12.1907 -18.8993 15.6687 11.8916 -12 2 5.86943 1.07894 11.3852 -0.461453 -6.159 1.34784 -13 1 6.94761 5.53992 2.37529 -6.07193 26.0011 19.9509 -14 2 6.56484 5.89454 3.23997 6.76459 -12.0871 -41.8379 -15 2 6.81469 6.2225 1.67437 0.333839 -16.9501 17.8189 -16 1 16.2464 10.2212 16.095 -30.9636 -1.96085 19.7441 -17 2 16.8891 10.4896 15.4774 30.9665 9.88757 -18.0257 -18 2 15.7638 11.031 16.3423 6.62567 -11.9253 -3.68232 -19 1 10.7594 14.9468 2.28506 -10.192 -15.3258 -5.27915 -20 2 10.552 14.3194 2.98639 5.50444 -0.296801 2.35986 -21 2 11.1642 15.6696 2.7411 11.3222 17.7739 6.10774 -22 1 17.1862 8.22111 10.8759 16.4539 0.643281 -9.91552 -23 2 16.576 8.81969 11.3105 -3.64966 6.67804 4.28607 -24 2 17.949 8.77387 10.614 -8.44523 -5.92405 1.0378 -25 1 14.6358 16.0024 16.3895 25.5058 -11.0228 4.42293 -26 2 13.7352 16.2786 16.3126 -22.3429 5.97271 0.576342 -27 2 14.7081 15.5263 17.2386 -3.54281 4.69451 -12.0743 -28 1 12.1273 13.3164 0.564829 -0.361627 4.24339 0.0908299 -29 2 11.7754 13.443 18.3303 1.85705 -5.04776 -15.4247 -30 2 11.6653 13.9884 1.07404 2.42612 -1.45379 10.2607 -31 1 9.30563 5.48822 3.87958 6.5447 0.0363683 25.4904 -32 2 8.87806 5.40536 4.77034 1.54217 -0.907852 -25.4465 -33 2 8.62277 5.52424 3.19838 -5.81373 -1.17005 3.72822 -34 1 1.59219 3.96918 11.5778 -9.84269 42.1113 -23.7424 -35 2 1.65598 4.94531 11.7448 -5.32168 -23.4604 1.30407 -36 2 2.08682 3.52502 12.2368 16.8537 -14.859 24.6718 -37 1 2.0876 6.92307 8.18563 -3.73767 -8.57072 -0.0346284 -38 2 2.39381 7.30463 9.00964 5.23298 7.68032 1.6714 -39 2 2.09597 5.97338 8.35948 -3.7573 0.82597 0.238295 -40 1 5.28961 4.49122 7.85762 -5.23337 8.41869 1.15392 -41 2 5.42981 3.54006 7.92701 -4.09922 -6.37036 -7.26013 -42 2 4.64396 4.70759 7.15783 7.0556 -5.183 4.67383 -43 1 3.36027 2.89954 17.3915 -17.4395 12.4687 22.0366 -44 2 4.05476 3.43419 17.006 5.24509 0.828911 -8.29254 -45 2 2.77379 3.5226 17.8911 18.871 -11.3769 -11.5396 -46 1 7.49453 5.42535 6.18785 1.1565 -0.337813 22.5495 -47 2 7.9164 5.96716 6.90215 -9.87324 -14.4944 -23.4171 -48 2 6.89327 4.79051 6.63979 12.0833 17.318 -7.46699 -49 1 9.81909 7.02563 12.0706 7.31099 -1.858 8.99458 -50 2 10.1534 6.27284 11.5881 4.21769 -4.6772 -1.38273 -51 2 9.09614 7.33889 11.5389 -11.6555 6.63577 -10.586 -52 1 13.987 3.72336 8.09074 -16.8343 16.962 -37.2017 -53 2 13.5442 4.52839 7.7245 12.4076 -19.615 9.33911 -54 2 14.2201 3.91921 8.97962 7.00657 7.67382 26.2916 -55 1 4.5104 17.1281 3.91533 10.7578 31.6451 -21.4766 -56 2 5.3439 17.6347 3.91183 -5.56531 -14.4645 11.3324 -57 2 4.01019 17.58 3.20396 0.717673 -14.6313 13.083 -58 1 16.3456 16.5752 10.4878 9.47486 -6.83722 -28.8723 -59 2 15.5139 16.524 10.9378 -17.3385 1.90191 12.1775 -60 2 16.1667 16.1386 9.62748 3.54118 4.50203 14.5107 -61 1 1.9669 4.78352 0.127126 -0.739304 -4.30462 13.1261 -62 2 2.4124 5.1813 0.904759 -4.07407 -0.50297 -16.3737 -63 2 1.70825 5.48663 18.1668 4.40273 7.87995 3.28325 -64 1 11.3312 13.2592 16.4181 -1.15069 -16.7597 -15.9919 -65 2 10.8158 12.4247 16.4648 10.4615 17.429 3.38388 -66 2 11.9137 13.1122 15.6483 -5.75273 4.84583 10.0297 -67 1 10.0951 10.9476 16.7865 12.4257 -21.5163 1.40398 -68 2 10.4762 10.0399 16.7888 -6.98476 25.4172 2.00859 -69 2 9.15392 10.8219 16.7533 -12.5538 0.302602 -1.38706 -70 1 11.8287 17.486 13.4829 -0.118354 -13.6364 7.15806 -71 2 12.4458 16.8683 13.0504 -5.40922 13.24 -3.88075 -72 2 12.1685 18.3769 13.3708 4.2975 6.3924 -3.60834 -73 1 6.40329 9.45666 12.3007 7.59953 -15.5921 -26.3915 -74 2 7.02951 9.14458 11.6116 -13.6176 6.52201 11.0115 -75 2 6.95635 9.88774 12.9378 9.38595 10.7935 13.1394 -76 1 16.3024 12.9052 2.74142 -15.9403 -16.7132 8.77179 -77 2 17.1501 13.3041 2.5727 9.16723 7.57391 -3.15506 -78 2 15.6647 13.6204 2.85813 1.6204 2.22565 -2.39426 -79 1 0.760847 12.751 5.87222 -24.7031 -12.948 -13.3423 -80 2 1.12648 12.6956 4.9713 -1.82207 2.12621 9.26767 -81 2 18.4428 12.5289 5.74368 26.1358 12.2861 6.31515 -82 1 5.29492 16.3822 18.4146 -5.77927 -1.1636 -2.25588 -83 2 5.45161 15.4933 18.0434 4.5004 13.3336 10.181 -84 2 5.72207 16.4863 0.6292 0.349856 -6.54957 -3.00829 -85 1 0.672446 7.71977 4.17015 11.9206 5.83738 -2.65809 -86 2 0.0599114 7.99601 3.47788 2.17241 0.0211014 0.560686 -87 2 1.51354 8.18303 3.96741 -13.409 -12.9126 0.0558484 -88 1 3.18041 9.04016 6.47644 -48.733 9.26031 0.132627 -89 2 3.67612 8.69495 7.19851 13.8171 -10.3779 15.348 -90 2 2.22175 8.86945 6.71565 32.4894 5.10639 -10.1715 -91 1 7.33809 10.425 16.1982 -13.7714 -1.76245 23.4597 -92 2 6.52669 10.798 15.8343 6.52641 -1.5478 0.375626 -93 2 7.11414 10.2397 17.1395 3.58358 2.1532 -21.3577 -94 1 11.0368 0.910412 5.00755 -5.03762 -2.37072 -20.9965 -95 2 11.0166 1.76948 4.5572 3.99116 -0.122414 9.27702 -96 2 10.8085 0.318039 4.26499 2.41704 1.78329 12.9529 -97 1 4.27055 2.90822 13.1584 -5.03414 2.69466 11.7405 -98 2 4.39065 3.48249 13.9384 2.16314 -12.4788 -5.29849 -99 2 4.11656 2.00207 13.4974 4.2297 10.0998 -5.7581 -100 1 8.47529 10.248 1.79037 -0.416679 -17.2671 7.19176 -101 2 8.23967 10.8662 2.49257 2.8179 1.08296 2.51337 -102 2 8.59639 9.37915 2.23271 0.0130336 16.1865 -5.8343 -103 1 10.3383 1.70852 15.4843 -18.7352 2.46602 -2.29408 -104 2 11.1863 1.36274 15.7269 17.9639 -3.17473 -1.31836 -105 2 10.261 1.74525 14.5183 4.02029 2.26456 4.98686 -106 1 2.61381 12.97 7.91629 0.377646 -9.00714 -10.2558 -107 2 3.20736 13.521 7.38885 -1.73045 4.27865 2.80704 -108 2 1.92972 12.6563 7.30106 5.76016 2.06086 0.889789 -109 1 3.8265 11.6489 4.94253 -18.049 0.292651 15.0893 -110 2 3.64515 11.1228 5.74952 0.240622 6.04317 -17.8646 -111 2 3.00147 11.7074 4.41136 14.7829 -0.870145 11.9003 -112 1 6.67003 14.5068 16.9871 0.195301 -8.52391 -8.20479 -113 2 7.30673 15.1853 17.2075 3.81359 1.00594 1.02421 -114 2 6.51415 14.5784 16.0351 -3.74805 4.58221 3.23833 -115 1 14.2005 14.4991 3.2542 12.2104 -4.1759 -13.149 -116 2 13.9664 15.4191 3.35064 -8.52353 7.22912 -0.280994 -117 2 13.8358 14.0368 4.00136 -6.61808 -5.66537 10.7242 -118 1 8.64986 18.0488 16.0994 -35.3958 -9.60596 -0.188096 -119 2 9.08138 17.255 16.4541 14.3634 13.9351 -5.51429 -120 2 9.16615 0.19969 15.9552 18.9441 -0.541676 3.30098 -121 1 4.69447 1.75392 4.88991 25.859 26.3088 -12.7751 -122 2 3.87089 2.24691 4.93296 -3.58784 0.203107 2.94233 -123 2 5.32887 2.35869 4.40805 -22.2668 -23.8988 10.2256 -124 1 15.0337 12.5563 16.5322 -9.42235 19.0778 45.1845 -125 2 14.5415 12.8308 17.3429 25.2588 -5.91919 -13.7907 -126 2 14.3516 12.6025 15.8912 -15.7131 -4.7436 -33.7881 -127 1 15.7107 18.4933 16.8499 14.0119 15.6823 26.0515 -128 2 16.2364 18.5256 17.6977 -11.7154 -4.95338 -28.5838 -129 2 15.2517 17.6535 16.8181 2.70767 -12.4638 1.72062 -130 1 1.36288 1.31672 16.6317 -8.11361 12.6727 12.78 -131 2 2.12452 1.88684 16.8387 -7.41596 -12.3761 -6.73343 -132 2 0.666274 1.64987 17.2352 10.0682 -8.10993 -10.4284 -133 1 18.2119 4.36953 15.9172 -1.70541 -5.24792 -22.7614 -134 2 17.9042 3.81192 15.1707 6.44647 9.66147 16.3107 -135 2 0.476259 4.62247 15.7042 -5.76089 -2.38794 2.9761 -136 1 12.1484 17.0613 16.1489 -25.1744 -26.2572 32.1897 -137 2 11.4087 16.4938 16.5203 28.1495 25.8696 -8.33389 -138 2 11.9925 17.0682 15.2174 -4.06343 5.18838 -23.7308 -139 1 16.1307 2.63053 18.236 -24.4255 7.46546 -12.7341 -140 2 15.654 3.45006 18.4862 10.3096 -12.6534 -4.96798 -141 2 15.8825 2.42572 17.3162 0.942238 5.76458 9.76029 -142 1 6.69125 13.7819 10.0957 6.51523 5.30674 14.72 -143 2 6.68166 13.4115 10.9958 -3.31201 0.605957 -8.104 -144 2 6.74207 13.0463 9.48799 -5.76864 -9.77159 -4.40801 -145 1 10.1909 18.4566 2.69612 24.6552 12.5235 -11.9688 -146 2 10.5208 0.299966 1.90483 -6.63917 -6.88653 20.5003 -147 2 9.33855 18.1401 2.45819 -23.0922 -9.86885 -6.30041 -148 1 3.05041 17.6833 6.1612 -20.7399 0.346779 9.3758 -149 2 2.11766 17.6882 5.81771 32.7543 -5.44367 1.96306 -150 2 3.663 17.6288 5.4193 -6.60477 0.357372 -5.21379 -151 1 12.6301 16.8021 7.91443 2.73044 3.22351 -7.20597 -152 2 11.8394 16.2829 7.68186 3.48899 3.70212 12.2186 -153 2 12.4619 17.4281 8.63963 -10.075 -5.48551 -5.536 -154 1 14.8863 15.2402 8.20999 -23.6436 14.8183 29.3151 -155 2 14.1404 15.8836 8.27066 14.7388 -14.8318 -6.56535 -156 2 15.2763 15.3549 7.35467 9.52302 6.19548 -12.651 -157 1 17.8321 18.2493 0.273835 -34.2521 -9.59248 -4.32979 -158 2 18.5224 17.6645 -0.0392514 10.753 2.02465 3.4369 -159 2 18.2087 0.412934 0.595185 14.0613 13.0178 4.00109 -160 1 0.763956 10.5262 1.39925 -10.0074 -57.9186 33.1602 -161 2 0.0205775 9.86382 1.5781 27.9288 29.6193 -5.5527 -162 2 0.446448 11.1766 0.811593 -14.5912 25.5328 -23.4764 -163 1 1.80037 12.2889 3.30512 5.17734 11.597 19.2466 -164 2 1.46139 11.5987 2.74824 -6.10095 -9.75588 -16.5262 -165 2 2.13675 13.0044 2.75129 -3.9772 -2.70365 -1.85909 -166 1 0.682885 17.2588 4.99366 18.5034 24.5267 -32.7679 -167 2 0.107172 18.0117 5.16246 -8.54671 -5.12892 6.2039 -168 2 0.50047 16.4742 5.48014 -13.5055 -14.6224 21.6265 -169 1 1.0645 0.823506 9.34737 11.8193 5.83131 5.68962 -170 2 1.36557 0.594309 10.2448 -8.52979 0.55273 -0.975829 -171 2 0.153783 0.559257 9.28231 -13.2671 -5.76719 2.40467 -172 1 16.771 2.35127 13.3608 4.58635 29.8799 -13.6101 -173 2 16.8279 2.7166 12.4388 1.57782 -15.3367 24.752 -174 2 16.4858 1.44141 13.3191 -2.28737 -11.3359 -2.05688 -175 1 2.68433 15.9539 12.0479 2.00481 -8.12072 21.99 -176 2 2.97356 15.5639 12.9056 -4.45908 8.74231 -22.8774 -177 2 3.1524 15.4962 11.3314 -4.16555 3.83231 7.28649 -178 1 16.3902 15.5703 6.15458 18.8333 21.1033 -24.533 -179 2 17.3221 15.5371 6.43733 -15.6071 -4.56317 -0.523174 -180 2 16.3697 16.3474 5.53712 -7.15193 -24.3314 15.8574 -181 1 5.78808 5.16844 11.811 1.07675 -5.38543 -7.05048 -182 2 5.68145 6.03537 12.2081 -3.48533 4.06917 4.5041 -183 2 5.0592 4.65006 12.1655 2.16361 -4.54815 -2.94322 -184 1 15.172 4.89144 0.795633 -0.620892 -0.594882 26.39 -185 2 14.9156 4.81116 1.75201 7.19669 -4.64536 -26.7766 -186 2 14.3985 5.20255 0.336699 -8.8444 5.20324 -3.46854 -187 1 16.3986 16.4119 1.90339 15.122 14.6556 -26.5352 -188 2 16.0454 16.7612 2.71133 -6.27107 5.29423 17.303 -189 2 16.8063 17.1873 1.44657 -8.45441 -18.3773 8.08233 -190 1 0.184762 4.82044 3.92309 -20.0167 36.2337 -7.4234 -191 2 0.305381 5.80234 3.92557 1.42835 -23.0136 0.864842 -192 2 1.01251 4.4465 4.18098 17.0496 -9.16948 9.65169 -193 1 2.95853 15.072 15.1235 -0.929158 -18.0667 1.08146 -194 2 2.81752 14.526 15.9315 -1.93517 21.6459 -9.19578 -195 2 2.47159 15.9015 15.2035 -0.281788 -0.150795 8.17547 -196 1 1.08884 14.6409 9.4443 27.3966 -12.5379 -34.1186 -197 2 1.70575 13.947 9.05916 -23.9186 28.888 17.798 -198 2 0.66831 14.2301 10.1769 -7.64803 -12.9163 21.0233 -199 1 13.5173 16.5215 11.5364 0.489599 15.4909 -5.38356 -200 2 13.0836 17.2895 11.1076 8.88627 -7.75363 7.54599 -201 2 13.0704 15.7764 11.1287 -2.36322 -6.26123 2.87696 -202 1 4.73898 1.52078 0.69167 -9.68217 -10.6702 17.6377 -203 2 4.07875 2.00526 0.184075 4.46446 1.98443 -3.98397 -204 2 4.22033 0.928191 1.27988 9.48282 8.28471 -14.387 -205 1 1.52478 18.5784 11.9214 -16.2358 21.4234 -4.1613 -206 2 1.51367 0.493465 12.7143 -0.730917 -3.29007 -5.80239 -207 2 2.22048 17.951 12.0321 13.8924 -17.5303 6.45556 -208 1 11.4148 10.1041 4.08036 9.63761 14.6797 -7.17105 -209 2 11.6092 10.6619 3.28786 -9.14527 -18.7957 16.2306 -210 2 12.2661 9.96891 4.5224 -0.931524 1.73008 -8.63915 -211 1 8.18373 12.2132 3.70486 4.04638 8.18109 41.2935 -212 2 9.0456 12.58 3.98139 -6.62274 -6.35725 -9.04284 -213 2 7.64552 12.2934 4.54 8.66084 -3.68417 -28.5646 -214 1 14.5934 4.00277 3.33714 14.4882 6.32576 -0.110592 -215 2 15.3087 4.27672 3.93937 -11.245 -6.6719 -0.591331 -216 2 13.7777 4.36055 3.68688 -6.37652 3.17854 3.04506 -217 1 5.71814 1.6621 7.57513 -5.5313 -4.02265 40.0153 -218 2 5.00295 1.12677 7.97081 8.59667 7.25176 -1.51046 -219 2 5.48447 1.71188 6.6706 -7.03261 -0.519715 -37.0679 -220 1 17.8819 0.996597 4.84385 3.28334 1.22129 -8.70029 -221 2 18.3735 1.40853 4.10428 -5.78677 -2.02928 14.9184 -222 2 17.7642 1.64161 5.55539 2.20556 -0.0657175 -7.03701 -223 1 6.81886 9.28778 4.52861 6.25722 -6.76526 -10.2791 -224 2 6.61832 9.39383 5.45723 -0.00817066 1.76549 8.49843 -225 2 7.7574 9.04758 4.4954 -4.05712 -0.0763234 -2.03313 -226 1 2.4854 14.759 2.04442 -7.64745 -7.92423 -28.9185 -227 2 3.31932 14.7218 2.51092 7.63377 -1.04104 5.23896 -228 2 2.65881 14.5612 1.09422 1.17207 5.04057 23.1132 -229 1 17.2643 12.9213 13.1026 -19.9619 15.9168 2.25648 -230 2 16.3761 13.2301 13.4207 25.7036 -1.66639 -12.6722 -231 2 17.7779 13.7212 12.8621 -11.3949 -9.92691 5.05246 -232 1 14.8558 10.5579 1.44832 -24.1837 -11.6243 -0.0449549 -233 2 15.2498 11.3496 1.79784 9.85962 12.147 5.79114 -234 2 13.9164 10.5877 1.7065 14.7293 1.68269 -5.02708 -235 1 5.67033 6.62258 4.57309 8.95784 -16.3381 4.76769 -236 2 5.78141 7.53495 4.33529 5.34224 19.3995 0.612293 -237 2 6.44538 6.37316 5.11369 -12.1071 3.69782 0.132968 -238 1 8.08484 8.3464 10.3723 -2.79238 1.81559 10.704 -239 2 8.60215 8.86766 9.74634 -1.18548 0.238269 1.84293 -240 2 7.34937 7.94467 9.9053 0.580319 -4.15939 -10.1337 -241 1 13.4382 18.465 5.66883 -2.12963 -16.204 3.95429 -242 2 12.6402 0.317353 5.43723 -0.0049589 1.74147 2.86213 -243 2 13.1409 17.7635 6.28441 4.99057 13.7489 -2.35078 -244 1 -0.0389125 2.60201 0.358484 20.6019 -11.619 5.06808 -245 2 17.6744 2.57403 18.7483 8.04315 12.368 -1.45646 -246 2 0.347515 3.47455 0.194182 -8.07269 -1.54831 -1.2857 -247 1 12.9609 10.9078 9.72363 -44.1168 29.5082 -8.54535 -248 2 11.9486 10.9818 9.7709 44.2995 -10.8859 -2.13595 -249 2 13.1901 10.0051 9.91101 -8.5598 -18.2315 3.87517 -250 1 0.590645 12.1909 11.1498 11.7969 16.2942 20.6903 -251 2 18.3214 12.2032 11.4307 -13.062 -2.39731 -5.9775 -252 2 1.05781 12.4788 11.9545 1.3761 -3.96073 -11.1532 -253 1 5.19979 7.35251 13.3459 4.96104 -3.5954 0.621761 -254 2 5.77554 8.05147 13.0099 -6.36891 3.58923 -1.12306 -255 2 5.62026 7.07364 14.1664 0.643961 -0.709679 0.08133 -256 1 1.17273 6.78721 11.9743 -37.7935 -22.2758 -19.6174 -257 2 0.361865 7.16229 11.5551 20.1673 -8.51661 10.9701 -258 2 1.7013 7.51605 12.2195 19.7686 31.2325 8.39364 -259 1 15.5313 9.74152 12.3525 -7.42661 26.8763 14.1834 -260 2 15.1354 10.6339 12.1691 17.2848 -32.3992 2.44097 -261 2 15.9001 9.83422 13.2442 -4.7827 -6.0868 -10.0384 -262 1 16.5842 12.6457 5.58229 -7.58554 26.2756 -26.1768 -263 2 16.3849 13.5701 5.8413 5.71516 -14.5282 0.0223018 -264 2 16.4193 12.6729 4.60395 6.10391 -10.0799 23.5706 -265 1 6.38601 9.81704 0.0456579 -23.7849 0.890546 -8.41533 -266 2 5.51671 10.1854 0.278669 9.54818 -0.234306 -0.813632 -267 2 7.00687 10.1562 0.67255 15.5644 7.03716 17.2844 -268 1 12.2684 6.05846 4.00919 -28.2934 -33.3926 21.5663 -269 2 12.263 6.7861 3.41661 0.234348 22.4834 -18.769 -270 2 11.3224 5.76736 4.06199 25.4812 4.82389 -2.50319 -271 1 0.373791 12.8792 0.072054 -11.107 3.80906 -1.77299 -272 2 18.9015 13.5268 0.779758 -5.73011 -3.33995 1.31101 -273 2 18.3694 13.1354 18.0395 6.43374 -1.82904 2.53089 -274 1 3.55692 18.7013 8.65073 14.893 -16.0199 -12.5754 -275 2 3.38339 18.1698 7.85699 7.36237 7.58391 1.53928 -276 2 2.68044 0.23403 8.96368 -11.3363 8.83032 5.06178 -277 1 7.32525 17.3963 4.4514 17.4309 29.7426 -3.23332 -278 2 7.82401 18.2131 4.74166 -23.0386 -26.7058 -8.39786 -279 2 7.43189 17.3694 3.48275 -1.39589 -2.42936 11.5599 -280 1 9.26525 17.1572 12.169 8.13396 -3.40366 20.592 -281 2 9.29678 16.2438 11.8433 -0.925088 7.81756 -3.33389 -282 2 9.96734 17.2329 12.8546 -10.0311 -2.0771 -17.5408 -283 1 13.2786 13.1508 8.01112 -12.5044 -28.1533 13.0431 -284 2 13.4287 12.5256 8.7581 -3.83031 10.1919 -19.0767 -285 2 13.9208 13.8439 8.10408 14.3758 9.62768 2.82629 -286 1 14.7717 2.95063 15.4663 23.0059 6.37496 -12.5686 -287 2 14.1149 2.31 15.1961 -5.56432 -5.96018 -2.11564 -288 2 15.3514 3.08539 14.6861 -8.35989 -8.63193 12.4086 -289 1 9.95789 15.6422 16.9764 -4.46993 0.793564 -8.8018 -290 2 10.2307 14.8148 16.5569 1.31144 -2.42354 4.42353 -291 2 9.44172 15.4 17.7473 1.0906 -3.95706 9.45227 -292 1 11.2531 8.54113 16.6333 5.17657 0.0418295 -8.84929 -293 2 10.6325 8.00272 16.1399 -5.6117 -5.11655 -0.169214 -294 2 11.5912 7.9918 17.3372 0.751532 -6.83429 5.96975 -295 1 4.09617 18.2775 16.8038 -1.75476 28.7193 2.74196 -296 2 4.5979 17.7227 17.3968 3.26159 -10.0112 3.6984 -297 2 4.13851 0.526798 17.2077 -3.53746 -18.1625 -9.44923 -298 1 2.30039 4.26982 8.91686 21.6694 -5.11589 23.5763 -299 2 3.26852 4.19272 8.75344 -21.2665 0.643644 3.82423 -300 2 2.17319 4.0769 9.88449 2.25335 4.47185 -28.5355 -301 1 9.91449 10.4045 9.82138 -1.36818 12.3774 -23.5261 -302 2 9.54718 11.2486 9.48103 5.13969 -13.6804 7.80682 -303 2 9.93694 10.4191 10.7736 0.214264 3.33848 13.7587 -304 1 9.74784 0.927945 10.8307 17.8645 8.52415 0.395599 -305 2 9.30432 0.217271 11.2949 -5.1784 -7.81016 -3.03012 -306 2 9.13824 1.32484 10.1982 -3.45577 -3.9008 2.04599 -307 1 9.17195 15.1281 10.2005 -15.5022 -1.44929 -2.09464 -308 2 8.96814 15.9769 9.77108 -2.08214 -7.76738 2.59404 -309 2 8.35001 14.5895 10.1068 18.2617 13.451 2.66111 -310 1 0.828362 9.74081 10.2167 22.8302 -4.53826 -35.6406 -311 2 0.863435 10.6794 10.4661 0.846835 -12.3508 -3.07098 -312 2 1.42185 9.63122 9.40918 -26.8549 6.26386 38.0517 -313 1 17.1622 4.86379 8.08044 2.41554 -11.1764 16.204 -314 2 16.3163 5.29453 8.26848 4.74994 -0.845127 5.21041 -315 2 17.4172 4.31929 8.8662 -8.72341 14.5987 -22.1578 -316 1 14.8039 14.6747 0.0449816 -17.091 -7.62196 19.0468 -317 2 15.3137 15.169 0.695817 3.50252 1.08273 0.82912 -318 2 14.0068 14.3765 0.533797 12.6241 2.78049 -10.2188 -319 1 3.85026 11.0642 9.5563 -2.44831 7.24975 -16.8488 -320 2 3.90516 11.4403 10.4374 -3.64435 1.57263 7.30128 -321 2 3.45144 11.7342 8.96857 -1.60708 -4.46554 10.9787 -322 1 11.3552 10.7376 1.50363 23.7004 17.8717 -7.90317 -323 2 11.5499 11.5913 1.05012 -4.60225 -16.5984 9.56505 -324 2 10.4091 10.6312 1.49605 -14.4596 -0.264671 -3.06241 -325 1 13.1456 7.20328 12.6021 -24.9249 -2.39855 5.22786 -326 2 14.066 6.96941 12.5913 17.2615 -6.20786 -1.13088 -327 2 12.6433 6.37391 12.7221 9.22616 8.00521 -2.5813 -328 1 9.63635 1.93928 0.908954 12.9918 3.25798 9.3487 -329 2 8.80616 1.72326 0.497356 -10.689 -0.461065 -8.23177 -330 2 10.2384 2.2422 0.224542 -0.105661 1.67982 -4.44056 -331 1 10.6547 13.4406 4.52244 4.65594 3.65244 26.3326 -332 2 11.5391 13.0824 4.73514 -13.2197 2.26822 -8.08889 -333 2 10.4444 13.96 5.32492 0.722291 -5.69425 -12.9779 -334 1 14.5068 1.61853 10.9473 1.56188 14.5139 4.90111 -335 2 15.3059 1.27791 10.528 -0.453964 2.70191 1.23402 -336 2 14.6742 2.57144 11.1203 -1.66622 -13.4066 -10.2612 -337 1 14.4999 12.0198 11.6401 -20.4 4.4823 -10.6844 -338 2 15.1901 12.5044 11.1683 0.00955556 -6.20474 -4.10181 -339 2 13.88 11.6279 10.9736 17.9431 15.8984 14.8698 -340 1 8.17874 5.12415 9.82106 -30.5984 10.5693 18.9492 -341 2 7.28241 5.07355 10.2519 27.6442 5.22023 -11.9731 -342 2 8.30253 4.26697 9.4335 2.62166 -17.6444 -4.58757 -343 1 1.47714 16.9429 18.4887 13.3148 33.7663 -28.6254 -344 2 1.86682 17.2437 17.6257 -9.89818 -8.00998 25.1444 -345 2 1.74527 16.0479 18.574 6.31239 -26.8006 -0.778427 -346 1 1.45374 17.3594 15.3268 42.8952 -1.15706 -0.811193 -347 2 1.42588 18.2136 15.749 -3.30828 11.7666 5.73369 -348 2 0.584657 17.0429 15.2318 -41.4551 -8.54136 -0.705167 -349 1 3.54007 5.76039 6.04888 -8.98595 6.80975 7.90297 -350 2 3.01039 6.43039 6.5207 7.85999 -10.8756 -2.65394 -351 2 4.1622 6.27284 5.52252 1.18276 -3.83664 -2.43702 -352 1 12.5413 9.50789 14.2278 14.1386 -34.2774 -1.94842 -353 2 12.9806 8.74877 13.7665 -10.1246 23.4373 5.48687 -354 2 12.3781 9.12309 15.104 -2.49329 10.5308 -3.54938 -355 1 4.07791 15.2392 7.05947 28.2061 -4.52306 7.60827 -356 2 3.62905 16.0551 6.82 -1.6925 3.55103 -3.37365 -357 2 5.05246 15.4367 7.04645 -25.4492 -3.49557 -3.60676 -358 1 0.767125 8.74429 15.1186 -1.35051 -1.02403 -4.71838 -359 2 0.502685 9.67668 15.1423 2.70563 -3.13172 -3.80763 -360 2 1.44028 8.65803 14.4206 -5.36892 5.64782 6.7911 -361 1 12.8556 8.29114 10.1154 40.5883 -11.1151 11.7349 -362 2 13.7543 7.93714 9.90509 -23.2563 4.30646 -4.77873 -363 2 12.8036 8.10553 11.059 -7.7965 -1.57596 0.639248 -364 1 15.3061 7.91627 3.47282 -42.6646 -27.0181 14.5138 -365 2 14.4087 7.67951 3.19876 7.83283 16.2655 -25.9683 -366 2 15.288 7.37548 4.27198 30.0578 14.5578 6.00353 -367 1 17.2193 6.75387 0.0348868 -24.2654 8.60155 -9.76068 -368 2 16.7331 5.97981 0.339573 3.08011 -1.47023 2.02216 -369 2 16.4984 7.35116 18.3587 20.6605 -10.5931 7.39935 -370 1 8.96527 6.96977 7.82312 -33.6536 -16.7811 13.5927 -371 2 9.86459 7.23854 7.79988 29.8916 7.79708 0.58286 -372 2 8.85329 6.36072 8.58482 2.84704 12.8992 -8.98126 -373 1 12.4369 0.615517 1.24835 5.12967 -8.6669 -10.2958 -374 2 13.1996 1.14046 1.50868 5.63 -3.81589 5.32704 -375 2 12.6841 0.248493 0.387703 -6.12727 4.87774 5.89397 -376 1 5.63437 15.0947 14.482 15.2573 18.1506 -1.5187 -377 2 4.74012 15.1756 14.8216 -5.87791 -1.19647 -0.853033 -378 2 5.96659 16.0211 14.4028 -4.19512 -21.3346 -4.32131 -379 1 3.78146 6.44452 1.71439 -10.0957 17.3086 -10.1533 -380 2 3.36154 7.20469 1.26344 3.84289 -8.07011 2.3383 -381 2 3.80108 6.73559 2.62781 1.97525 -3.80667 6.02801 -382 1 3.89131 11.3886 12.3597 10.4858 -4.45626 -8.95185 -383 2 4.75702 11.7925 12.5217 -6.56671 -1.88331 -0.935479 -384 2 3.25208 11.9718 12.7596 -7.39976 8.19237 6.18945 -385 1 5.30831 3.87649 15.7567 -11.2019 61.1278 12.0088 -386 2 6.01892 3.27998 15.6709 29.6235 -28.0721 -9.85567 -387 2 5.7476 4.76544 15.8793 -15.8563 -28.9516 -7.19779 -388 1 14.1175 10.173 4.66017 9.40425 -19.9217 -33.2768 -389 2 14.1461 9.82294 5.54158 6.86029 -3.38102 17.8715 -390 2 14.6328 9.51646 4.11155 -16.0552 24.3993 16.1239 -391 1 7.5636 17.329 9.02789 1.81886 -5.76611 4.78707 -392 2 6.9813 17.6417 9.74433 4.383 2.36677 -11.0761 -393 2 7.91242 18.0661 8.5041 -5.60089 1.56926 3.7162 -394 1 4.54646 14.4437 3.82391 2.35855 8.70422 24.1238 -395 2 4.58695 15.3758 4.17596 -1.73775 -31.732 -9.36156 -396 2 4.50325 13.8127 4.58585 2.14298 18.0212 -18.4803 -397 1 14.2437 7.3639 15.8726 24.9361 2.31774 6.81444 -398 2 15.0991 7.30759 15.3921 -17.5628 0.546592 9.39404 -399 2 14.5002 7.74932 16.7373 -8.89015 -4.19374 -15.8798 -400 1 3.04207 18.4209 1.96748 -18.4085 17.9201 24.7102 -401 2 2.5353 17.8449 1.40649 -4.22111 -10.717 -13.4847 -402 2 2.35407 0.262093 2.48798 16.8127 -9.3976 -15.4809 -403 1 7.96924 1.62215 4.56344 31.9424 -9.467 0.421552 -404 2 7.35201 1.92948 3.90341 -1.64239 4.88827 -11.6355 -405 2 8.85795 1.52282 4.13815 -26.2226 6.52533 8.08337 -406 1 2.457 14.1626 17.6995 -18.6259 -8.83368 10.0969 -407 2 1.68725 13.6009 17.9701 23.9808 13.2635 -8.93306 -408 2 3.24279 13.6711 17.9492 9.2771 -5.34798 1.51385 -409 1 0.927142 1.91914 13.8849 28.4694 2.81528 -14.4963 -410 2 1.17928 1.66855 14.7668 -1.31862 -2.11333 16.1229 -411 2 -0.00784116 2.01924 13.8762 -26.8609 -0.0423979 -2.90492 -412 1 4.3639 0.116891 13.871 19.5154 5.98388 -10.2249 -413 2 5.3312 18.592 13.8382 -18.25 -1.84578 0.0905254 -414 2 4.09014 18.5553 14.7613 -1.68072 -4.35498 12.29 -415 1 7.32185 0.935992 18.4254 -25.1976 4.88188 40.3736 -416 2 7.29261 0.583526 17.5599 3.22929 -13.7772 -30.1977 -417 2 6.39141 0.906009 18.7671 22.6248 8.40202 -10.9225 -418 1 15.9043 18.3822 13.9598 -30.4853 6.92778 -31.02 -419 2 14.9691 18.5865 13.6701 32.1757 -7.76669 18.1984 -420 2 15.9697 -0.290473 14.9111 -4.96086 4.78357 11.6174 -421 1 10.2566 4.62301 16.2429 -20.4053 -21.3362 -19.7333 -422 2 11.1923 4.47268 16.3843 6.75918 3.74651 0.0845893 -423 2 9.94726 3.80759 15.7722 8.97755 19.5704 18.0095 -424 1 15.9188 17.665 4.49409 -30.8876 16.8748 5.69015 -425 2 16.5463 18.3904 4.38809 -0.624131 1.21894 5.03495 -426 2 15.0755 18.0798 4.84388 28.6139 -15.2662 -13.1828 -427 1 6.9464 17.5119 13.903 30.1459 16.134 14.6047 -428 2 7.45538 17.7973 14.7126 -14.438 -11.5296 -22.8133 -429 2 7.62564 17.4897 13.1926 -14.0494 -3.94126 11.1274 -430 1 13.2241 6.43487 6.53037 -11.3028 -4.49966 -3.41689 -431 2 14.1722 6.56035 6.47079 5.41657 3.67276 -3.81812 -432 2 12.8747 6.35097 5.62176 7.42053 0.356932 11.8509 -433 1 7.85865 2.26615 9.45505 -4.28533 -3.16859 -37.0089 -434 2 7.29966 2.29372 10.2234 -12.0252 -4.85104 14.2867 -435 2 7.31757 1.89726 8.71059 11.6806 10.5906 18.7024 -436 1 15.1499 14.8389 13.7285 -7.78284 7.72319 0.275575 -437 2 14.8617 14.9509 14.6481 -0.524909 3.36892 -5.65775 -438 2 14.6832 15.507 13.1912 6.48748 -10.1003 7.43034 -439 1 9.39784 8.36731 3.82962 2.5344 -9.0015 0.237957 -440 2 10.2136 8.88179 3.87227 -2.41531 -0.25237 0.330419 -441 2 9.66909 7.4454 3.98022 -9.00345 8.8328 -4.59515 -442 1 17.7291 13.5977 16.4646 5.88425 13.7422 -6.32319 -443 2 16.779 13.4368 16.4502 -3.47507 3.66531 -1.64514 -444 2 17.9175 14.4327 15.9665 -10.227 -20.4783 11.0606 -445 1 4.89529 10.4518 2.85531 35.8078 -15.8912 -9.72696 -446 2 5.76001 10.066 3.12945 -20.0856 5.21459 -7.60385 -447 2 4.65599 10.9551 3.62329 -7.19184 9.4675 7.77805 -448 1 3.68184 8.40606 9.96257 -7.06038 -13.6752 25.4145 -449 2 3.73025 9.3314 9.75201 2.05841 13.8137 -4.67922 -450 2 3.5201 8.39907 10.9276 1.35511 -1.83367 -14.7667 -451 1 15.9506 6.91676 5.90036 8.23349 -12.8437 -5.59708 -452 2 16.7283 7.39089 6.23923 -5.44721 -6.23743 -4.31526 -453 2 16.2459 6.04307 5.54881 -4.37327 20.9496 12.2757 -454 1 15.2047 7.21919 9.02648 -8.23364 16.7266 -25.0777 -455 2 16.0013 7.62239 9.37026 6.97324 -0.496136 10.989 -456 2 14.9764 7.76869 8.23928 2.79192 -13.8116 16.1423 -457 1 6.18989 12.8346 12.7303 -2.33267 17.6694 7.57139 -458 2 6.82101 12.228 13.1265 8.54383 1.14333 3.13472 -459 2 6.09938 13.6243 13.3122 2.17121 -15.6415 -7.8487 -460 1 12.1177 4.51675 13.1173 40.066 24.623 8.84127 -461 2 12.3608 4.67527 14.0558 -10.9347 -6.25445 -11.8552 -462 2 11.2865 4.0907 13.0625 -30.7168 -15.659 3.72413 -463 1 11.4382 8.09379 7.90765 11.4031 -1.65515 0.349674 -464 2 12.1555 7.64923 7.40412 -12.1024 3.57709 12.4555 -465 2 11.7306 8.14579 8.84607 -3.22191 -0.660368 -24.1915 -466 1 17.0422 10.838 7.59458 18.8696 -14.9771 -17.3127 -467 2 17.8015 10.2845 7.30277 -16.9558 5.34042 10.7777 -468 2 16.8989 11.446 6.8574 -4.66599 0.747798 1.74373 -469 1 5.2881 18.0926 10.8094 -12.0199 -6.67836 -5.57022 -470 2 4.87565 17.5902 11.533 4.52174 5.42574 -9.9319 -471 2 4.66447 18.0398 10.0548 7.40461 3.40643 11.786 -472 1 7.61349 17.4864 1.6652 -5.64906 3.24499 15.5952 -473 2 7.84327 16.7088 1.17852 12.3306 -20.6776 -4.28559 -474 2 7.74119 18.1865 1.04014 -3.89506 18.5858 -12.7246 -475 1 1.91944 12.8991 13.6003 2.94725 10.7513 13.4495 -476 2 1.49936 12.2949 14.2301 -1.35275 4.24281 -4.32331 -477 2 2.12078 13.7179 14.107 -1.08361 -15.4355 -11.6139 -478 1 9.36899 6.74386 14.7638 -2.26814 18.4847 -3.39127 -479 2 9.81478 6.02606 15.213 8.95117 -11.473 0.808352 -480 2 9.85086 6.98618 13.9577 -2.76657 -9.1339 3.81591 -481 1 15.2853 4.27459 10.7783 -6.29839 -2.79317 -1.65183 -482 2 16.2088 4.11106 10.5808 3.62417 -3.44414 3.50356 -483 2 15.3067 4.91761 11.4912 -1.69264 4.92972 1.1484 -484 1 11.3393 6.23844 0.0959214 -19.2017 -19.0623 -2.27733 -485 2 11.4465 5.27934 18.8311 9.36926 7.99257 -4.22996 -486 2 10.3892 6.29463 18.5179 14.2332 9.643 5.73673 -487 1 18.5128 11.4549 14.9487 -3.47415 -8.47336 -12.1105 -488 2 18.0135 11.8846 14.234 9.23154 -3.06455 1.62932 -489 2 18.3213 12.0172 15.6945 1.79799 8.69016 10.3557 -490 1 7.01602 9.27569 7.3226 -14.4634 -16.8581 15.1781 -491 2 6.67273 8.48369 7.80259 5.98597 16.4947 -15.5019 -492 2 7.96023 9.16216 7.29002 13.6661 -3.40194 -2.89589 -493 1 18.3593 15.3216 12.2421 14.2565 8.37053 -9.09139 -494 2 0.609114 15.6531 12.0121 -9.26774 -5.34503 6.02371 -495 2 17.7657 15.7501 11.6106 -0.96984 1.15192 3.02291 -496 1 16.5123 4.36636 5.2899 -20.1169 0.0802899 32.1896 -497 2 16.6197 4.39367 6.27015 0.689823 -6.50354 -17.1519 -498 2 17.3637 4.55338 4.93619 30.7718 -0.208347 -14.1282 -499 1 17.7452 3.18489 10.789 3.81546 21.3325 5.47337 -500 2 18.6747 3.34524 11.0396 -11.7638 -6.52287 -4.76545 -501 2 17.6832 2.38146 10.2881 5.2294 -17.628 -7.02183 -502 1 12.3161 18.6216 10.0891 7.2643 12.1904 3.38538 -503 2 11.4836 0.405415 10.3905 15.4316 -4.87983 -6.88019 -504 2 13.0526 0.636416 10.1289 -21.6037 -8.70048 2.57237 -505 1 10.3866 9.75789 12.4872 13.2725 15.9888 14.5072 -506 2 11.1625 9.86545 13.086 -15.7493 -4.39745 -10.7974 -507 2 10.2528 8.81785 12.4 2.63286 -10.7197 -2.15993 -508 1 0.710964 2.68685 7.1375 -0.1398 22.218 7.12103 -509 2 0.988905 3.47272 7.66294 -4.49485 -18.6961 -10.7978 -510 2 0.93208 1.94131 7.68754 4.63119 -8.38422 8.20051 -511 1 0.281684 15.3172 6.85959 12.828 -38.7344 -20.2135 -512 2 0.500898 15.7193 7.67574 7.5107 6.97721 30.9172 -513 2 0.662709 14.3998 6.92418 -16.2289 29.7866 -9.89698 -514 1 17.0547 6.94606 15.0133 0.165691 -3.90506 -0.393601 -515 2 17.812 7.5465 14.9118 -2.55694 -6.08978 1.76467 -516 2 17.3809 6.10212 15.3719 1.63232 8.8395 -1.4121 -517 1 9.12112 12.493 8.02809 -41.9273 18.4298 17.1595 -518 2 9.51251 11.917 7.38329 0.012751 -17.4797 -14.5944 -519 2 8.13115 12.5622 7.88239 38.3085 -7.50107 -2.24579 -520 1 1.15265 1.71178 2.84381 -8.4531 -11.9611 -9.59212 -521 2 1.05399 2.26522 2.05124 -0.803687 -1.8039 9.5303 -522 2 1.83355 2.04817 3.41993 6.13064 16.5152 3.77918 -523 1 4.1533 15.0772 10.0179 -3.20174 -0.437736 -9.29092 -524 2 3.98656 15.1016 9.06421 1.0299 1.2944 4.52592 -525 2 5.05261 14.7702 10.1253 7.00528 -3.42074 -2.93025 -526 1 7.40026 2.22746 14.7687 6.49168 5.19513 -3.0061 -527 2 7.05161 1.63346 14.1063 -3.12724 -4.90201 -3.09738 -528 2 7.91685 2.87588 14.258 -12.5256 -3.95349 11.2802 -529 1 18.373 14.546 2.1576 32.8202 -8.56769 3.71586 -530 2 0.641523 14.7991 2.40659 -13.3331 -4.12423 -2.43111 -531 2 17.8688 15.3457 2.17573 -14.9783 16.0191 -2.18472 -532 1 10.0269 2.72027 12.9069 6.62939 -13.0178 -15.3878 -533 2 10.0552 2.15154 12.1041 -3.85604 9.52515 15.5624 -534 2 9.22213 3.24102 12.837 -1.7712 4.41938 -1.42751 -535 1 2.97754 8.87028 12.9985 -9.05038 -0.677068 -3.47801 -536 2 3.45417 9.69118 12.8049 -4.31376 -0.734034 1.18179 -537 2 3.62806 8.2766 13.3769 7.01874 -2.97808 -1.19575 -538 1 3.19567 8.6035 3.77658 -19.8399 -15.185 62.8422 -539 2 3.69787 9.2024 3.27039 20.7823 26.7884 -21.1607 -540 2 3.25417 8.93577 4.73429 1.71088 -18.6185 -45.3432 -541 1 5.68333 7.2353 8.59567 4.24349 7.94903 8.11652 -542 2 5.64033 6.27333 8.54735 -2.49289 0.630165 -0.0839225 -543 2 5.00997 7.53803 9.22801 3.10928 -6.89318 -6.51723 -544 1 14.901 1.57394 1.8387 15.5968 1.99798 -17.643 -545 2 15.036 2.2757 2.46438 -7.07983 8.8607 13.8203 -546 2 15.4483 1.85956 1.08282 -11.9705 -11.4344 6.74504 -547 1 8.60581 15.0641 0.724175 -1.0343 -0.581701 -1.65436 -548 2 9.36267 14.9264 1.3224 -11.0408 7.07619 -5.07103 -549 2 7.85377 14.5885 1.11097 4.42293 -0.805501 -0.698164 -550 1 15.4669 1.42093 7.20398 -6.02567 -16.758 -12.9624 -551 2 14.8047 0.91537 6.67859 11.4397 13.2212 12.6179 -552 2 15.1632 2.33261 7.23494 -7.42764 0.585266 4.6538 -553 1 4.96609 12.9239 18.4605 4.9692 1.49742 18.5571 -554 2 5.35493 12.9668 0.719228 -7.36506 -0.705061 -15.6984 -555 2 5.64055 13.3191 17.899 -0.422768 -0.432726 -0.922633 -556 1 15.3869 8.64959 18.0541 15.2167 5.00615 -15.1922 -557 2 15.9585 9.21901 17.4831 -18.3202 -12.4364 12.18 -558 2 15.1184 9.19177 0.153179 1.36579 6.92031 5.44875 -559 1 12.0051 3.11685 18.332 2.92261 2.37371 -0.430118 -560 2 12.2267 2.91556 0.611981 0.907964 -7.8545 -12.3252 -561 2 12.4512 2.48545 17.7302 -5.34745 5.71129 14.8863 -562 1 13.1901 12.7142 5.17454 1.37013 -5.58194 -4.10925 -563 2 13.4698 11.8626 4.7966 3.05379 7.74077 7.48289 -564 2 13.3871 12.6804 6.11832 -0.290674 -0.040691 0.190289 -565 1 6.14326 7.19304 0.194857 -1.9202 -41.4233 1.79985 -566 2 6.22321 8.10871 19.0299 -3.97355 27.3971 1.06104 -567 2 5.34431 6.86352 0.645447 4.46952 5.26437 -3.48858 -568 1 17.7307 15.8888 14.9367 -21.823 -0.594011 -1.7362 -569 2 16.7484 15.9241 14.9389 21.2696 3.13718 0.352088 -570 2 17.9521 15.7271 14.013 1.78287 0.501162 -2.11552 -571 1 13.1218 0.925759 16.6825 5.50042 -3.78674 2.95198 -572 2 14.072 0.793445 16.8378 -4.97223 1.91263 -2.37602 -573 2 12.7827 0.0340456 16.5234 -2.01103 3.41826 1.69274 -574 1 10.8951 14.5133 7.41586 13.7556 -0.655539 -10.0126 -575 2 10.113 14.0867 7.762 -7.55253 -2.39401 4.078 -576 2 11.587 13.8348 7.46973 -1.14 7.89944 2.21203 -577 1 17.6887 8.43188 2.14728 0.189858 20.0466 16.1607 -578 2 16.8137 8.45099 2.54699 -1.17102 1.13639 1.13697 -579 2 17.5844 7.88298 1.39033 0.906265 -19.3865 -19.2668 -580 1 12.4753 7.78007 2.02858 4.8513 20.3782 0.840615 -581 2 12.1866 8.68618 1.79587 0.511972 -15.0552 5.00442 -582 2 12.026 7.17575 1.43189 -2.95773 1.13832 -8.42618 -583 1 12.0482 14.5597 10.5042 0.0757192 -7.5571 -35.1431 -584 2 12.4064 14.4181 9.58152 -17.4466 3.18024 31.1693 -585 2 11.0871 14.7065 10.4137 10.382 -0.64313 -2.04102 -586 1 6.77399 6.81718 15.4895 -2.25325 13.5751 22.5023 -587 2 7.66157 7.15195 15.2455 -13.2429 -8.30723 6.82645 -588 2 6.46823 7.3192 16.2828 11.602 -10.345 -19.2772 -589 1 7.96932 4.46689 13.3146 44.2968 21.2749 25.8476 -590 2 7.30275 4.56825 12.6635 -24.5307 9.83264 -18.6775 -591 2 8.36434 5.36687 13.4905 -14.8867 -29.3495 -5.61281 -592 1 13.3256 12.2141 14.3822 1.63527 0.767161 7.05401 -593 2 13.3071 11.2456 14.3976 -5.0343 3.13323 -4.4607 -594 2 13.6638 12.4664 13.5147 0.299935 -1.6824 -0.371902 -595 1 14.5332 9.57639 7.29372 1.70864 -17.4355 -8.36329 -596 2 15.3543 10.0193 7.49698 9.6305 7.8311 1.84335 -597 2 13.8455 10.0241 7.76467 -11.6358 9.67674 12.3645 -598 1 12.6873 16.8129 3.32056 7.83014 22.6359 -6.17069 -599 2 12.905 17.3242 4.12577 -3.6908 -4.91509 -14.526 -600 2 12.6713 17.4548 2.56832 -2.22777 -11.4506 21.1383 -601 1 1.00404 7.03926 17.3541 -3.3312 4.1638 -9.33324 -602 2 0.198847 6.6977 17.7452 -7.86562 1.94891 9.68399 -603 2 0.682364 7.69734 16.7196 12.0745 -4.24482 -2.37704 -604 1 12.9524 4.87174 15.7195 8.90342 0.650689 -3.85785 -605 2 13.7851 4.36673 15.5939 -16.3603 12.0475 7.07164 -606 2 13.1756 5.81397 15.8059 7.81047 -7.07308 -0.568692 -607 1 2.31363 3.41121 5.09984 1.34414 -8.27729 12.6429 -608 2 1.77118 2.94066 5.78541 14.4044 18.7697 -14.1923 -609 2 2.78995 4.15649 5.52715 -11.381 -10.4766 -6.15296 -610 1 8.18617 10.9369 13.7076 0.678078 1.53711 40.2692 -611 2 8.26353 10.8511 14.7174 0.0908521 -0.97824 -49.4206 -612 2 8.97116 10.5326 13.3071 -0.268246 2.83437 5.42064 -613 1 12.9797 1.57395 13.2253 -11.1668 13.2146 -3.30054 -614 2 13.4836 1.606 12.3812 -13.0456 2.80048 17.4401 -615 2 12.3844 2.37352 13.292 24.5144 -24.3843 -9.90982 -616 1 6.623 13.6575 2.08401 -19.1133 11.282 9.3836 -617 2 5.9939 13.9784 2.7781 14.9337 -6.87798 -17.2483 -618 2 7.26745 13.1178 2.55198 -2.04458 -0.845032 2.89429 -619 1 15.8406 6.42424 12.5401 -13.2713 -11.8586 11.2716 -620 2 16.4194 6.98592 12.0445 9.49352 10.2235 -13.5209 -621 2 16.1454 6.51524 13.4484 4.14662 -0.822673 1.52229 -622 1 16.7707 0.701968 9.54479 -0.33564 -15.5889 9.3319 -623 2 16.6398 18.4357 9.88026 3.64558 8.61996 -2.27841 -624 2 16.2643 0.755347 8.72872 -0.899564 4.78829 -7.90839 -625 1 6.16924 11.6733 8.25771 14.6298 -10.0406 -3.26225 -626 2 5.33846 11.3866 8.66461 9.26092 -3.17897 1.03444 -627 2 6.69681 10.8652 8.03849 -20.9756 15.4878 5.14008 -628 1 2.79271 8.6573 0.35403 -23.76 -9.02274 -22.2632 -629 2 2.25448 8.23641 18.2541 16.977 17.0562 34.1458 -630 2 2.21462 9.29512 0.821612 5.57875 -9.71134 -10.0126 -631 1 10.106 10.3292 6.60358 -3.61165 1.9136 -10.2284 -632 2 10.6792 9.71276 7.06962 0.244318 -4.43661 2.14915 -633 2 10.3272 10.2595 5.65755 0.987804 2.37269 11.054 -634 1 6.86896 15.7547 6.74185 -9.45188 0.350857 10.5778 -635 2 7.01957 16.2495 7.56813 1.20841 -3.75655 -8.95365 -636 2 6.86937 16.4078 6.03145 5.97827 -1.66506 -1.56051 -637 1 6.52554 12.9289 5.84178 -0.357514 -5.09084 -2.41361 -638 2 6.62829 13.798 6.2286 3.16894 9.75908 1.28602 -639 2 6.09212 12.3914 6.51525 3.69897 1.96572 0.733322 -640 1 16.7568 12.518 9.72465 -9.23185 -13.2632 0.47822 -641 2 16.902 11.7866 9.09243 0.130969 14.0381 8.74694 -642 2 17.3592 13.2171 9.48659 4.61146 3.47499 -3.98224 -643 1 6.24919 2.86496 2.77119 -11.0856 -12.869 -3.38869 -644 2 6.47325 3.75226 2.51474 6.07925 14.4727 -0.649249 -645 2 5.68088 2.55654 2.04869 4.52067 -4.17334 4.94091 -646 1 10.7277 3.04594 3.24275 -5.68944 3.06595 0.875255 -647 2 10.1765 3.79746 3.50451 2.82785 -3.23936 -2.03517 -648 2 10.278 2.63972 2.48897 0.815959 0.513447 0.723514 -ITEM: TIMESTEP -90 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.787 6.66827 17.9842 -16.1402 -3.16192 1.04025 -2 2 7.92621 6.66814 18.4555 15.1954 -0.455805 -12.5376 -3 2 8.71175 6.0436 17.2441 2.25338 3.19171 10.1252 -4 1 0.22099 8.38854 6.75163 1.7867 -5.58088 53.0968 -5 2 0.258391 8.22026 5.83332 5.30707 -13.3892 -38.1472 -6 2 0.61579 7.61263 7.23543 -10.6686 22.8516 -15.6901 -7 1 8.66795 0.370206 6.9239 18.6241 3.37743 -9.56875 -8 2 9.59619 0.315354 6.61478 -16.3273 1.21351 7.23111 -9 2 8.27983 1.03351 6.33448 -2.90229 -5.54848 4.92815 -10 1 6.43573 1.74596 11.7835 34.1799 -16.6044 -13.764 -11 2 5.93979 2.40996 12.1988 -27.1883 29.6469 18.8725 -12 2 5.80753 1.07598 11.5419 -8.40397 -16.9848 -5.34211 -13 1 6.95318 5.50156 2.37044 -56.4905 40.6357 15.9903 -14 2 6.31995 5.85318 3.09808 38.0444 -22.8427 -29.8317 -15 2 6.63738 6.03683 1.59693 20.7004 -19.4106 17.4304 -16 1 16.2563 10.1963 16.0713 -10.5934 -3.27458 3.94447 -17 2 16.9716 10.3961 15.4827 15.3322 4.9096 -4.70747 -18 2 15.8903 11.0434 16.3496 -2.84586 0.096923 -3.72852 -19 1 10.8156 14.9572 2.29652 -13.5477 -14.1276 -10.2117 -20 2 10.6343 14.4303 3.07787 2.79926 -3.05354 4.26547 -21 2 11.1766 15.7627 2.6355 11.3372 16.7492 6.7502 -22 1 17.2002 8.21443 10.9436 15.2126 5.40823 -8.20499 -23 2 16.6458 8.84622 11.4125 -4.33506 2.62691 -0.328418 -24 2 17.9515 8.74734 10.6145 -8.68143 -7.05886 2.54317 -25 1 14.6067 16.0259 16.3377 27.3765 -5.03456 2.51249 -26 2 13.6996 16.2768 16.4047 -22.3019 9.86517 -5.17321 -27 2 14.7963 15.6285 17.196 -1.96556 -8.36093 -2.03831 -28 1 12.1458 13.2907 0.563101 15.519 -14.4585 7.5186 -29 2 11.8598 13.3671 18.2945 -8.9445 7.51312 -6.12139 -30 2 11.6592 13.8773 1.15113 -3.3891 6.78651 -5.827 -31 1 9.32161 5.49231 3.86239 -40.7454 -0.097831 27.7 -32 2 8.82419 5.45502 4.73277 24.2157 -2.28744 -25.4595 -33 2 8.56838 5.45751 3.23664 18.1191 1.43276 -0.568008 -34 1 1.5546 3.92475 11.5547 -2.15894 45.2634 -4.40984 -35 2 1.55046 4.88574 11.8201 -3.55694 -26.3933 -6.97822 -36 2 1.92957 3.45678 12.2837 10.4321 -13.9157 16.7147 -37 1 2.10319 6.96614 8.15085 -9.44208 -8.37285 -17.308 -38 2 2.4095 7.43328 8.92365 8.57391 0.445975 10.2393 -39 2 2.10294 6.01871 8.3456 1.70875 2.69997 7.84786 -40 1 5.23855 4.482 7.82422 -14.5525 -1.69806 -15.7353 -41 2 5.37847 3.52895 7.72628 3.24739 1.15002 6.52498 -42 2 4.55634 4.7134 7.1559 12.5144 1.33119 10.811 -43 1 3.38552 2.88255 17.3879 -7.38377 33.0145 14.859 -44 2 4.08387 3.35622 16.9066 -6.09174 -4.5148 -0.339366 -45 2 2.81217 3.57956 17.8286 22.0641 -22.8641 -14.398 -46 1 7.5324 5.43864 6.19559 -6.90202 6.90038 35.1799 -47 2 8.08818 5.95892 6.84983 -22.5477 -17.4794 -25.4925 -48 2 6.78022 5.04202 6.71812 26.5249 9.35209 -13.645 -49 1 9.82024 7.03039 12.0775 19.8901 0.0780072 21.9724 -50 2 10.117 6.21395 11.6931 4.07542 -9.22938 -4.80372 -51 2 9.09589 7.30435 11.5485 -23.243 9.22364 -20.0663 -52 1 13.9806 3.7694 8.09667 -19.6388 4.31534 -31.7671 -53 2 13.3819 4.49155 7.81719 15.167 -9.87345 1.12215 -54 2 14.3046 4.00637 8.94223 9.52837 8.93591 30.7953 -55 1 4.52742 17.134 3.88467 -0.450754 13.2049 4.39156 -56 2 5.37483 17.5703 4.13521 -18.32 -2.84079 -10.9512 -57 2 3.94957 17.708 3.32475 23.4139 -10.9615 8.41036 -58 1 16.2726 16.5634 10.552 38.1711 -6.17539 -26.5181 -59 2 15.4837 16.6086 11.0514 -31.396 0.528555 16.213 -60 2 16.0986 15.9648 9.80419 -5.24542 6.81385 7.69127 -61 1 1.94125 4.78402 0.0638345 24.0582 25.3647 11.1071 -62 2 2.62474 5.1599 0.67023 -17.1428 -14.5257 -4.57865 -63 2 1.76164 5.54704 18.141 -7.28608 -7.40463 -3.41134 -64 1 11.2518 13.2771 16.4354 2.60185 -12.9515 -12.3757 -65 2 10.6918 12.4717 16.5304 19.7397 14.6013 -5.52798 -66 2 11.8919 13.1107 15.7025 -16.8897 -0.368153 14.685 -67 1 10.0575 10.919 16.7613 6.16873 -18.0385 3.66167 -68 2 10.4442 10.0133 16.8612 -13.1447 30.924 -0.515142 -69 2 9.09987 10.8482 16.7186 0.711039 -4.16381 0.34444 -70 1 11.8614 17.5086 13.5019 6.48767 -7.71286 -13.5562 -71 2 12.4999 17.0938 12.8959 -9.94411 -4.10313 8.27478 -72 2 12.0757 18.4326 13.4127 -0.0140719 16.2542 2.74368 -73 1 6.39981 9.50139 12.337 -4.6648 -8.8035 -19.3883 -74 2 6.97362 9.2422 11.6012 -0.80266 1.15987 5.77958 -75 2 6.9622 9.95325 12.9581 6.38846 6.66359 6.95977 -76 1 16.2975 12.8974 2.78222 -12.345 -27.8929 4.9875 -77 2 17.1496 13.2141 2.51749 15.349 9.48057 -2.38836 -78 2 15.7502 13.672 2.87844 -10.3717 9.81447 0.854078 -79 1 0.774 12.7819 5.86324 -32.223 -2.64552 -12.7856 -80 2 1.10971 12.9185 4.95432 -4.25214 -7.81578 11.8108 -81 2 18.4306 12.6074 5.76822 36.341 8.50215 1.05579 -82 1 5.29891 16.3721 18.4261 6.47 -16.9938 9.7884 -83 2 5.51669 15.4746 18.1046 -4.53971 18.6444 -2.10572 -84 2 5.85038 16.4657 0.570301 -5.83847 6.29943 -2.02707 -85 1 0.695227 7.70772 4.16735 36.5725 18.4792 -22.7587 -86 2 0.10368 7.96447 3.43723 6.76909 -3.37176 10.733 -87 2 1.60166 8.10351 3.91123 -45.3891 -20.8895 14.9183 -88 1 3.19365 9.10151 6.50287 -37.0597 -13.4257 3.63648 -89 2 3.6513 8.68447 7.23829 0.216969 0.250287 -1.31356 -90 2 2.24726 8.75126 6.54108 37.1121 17.8096 0.286984 -91 1 7.35199 10.4473 16.1779 -19.0362 -10.3824 27.97 -92 2 6.56517 10.9544 15.9216 9.49501 -5.7134 5.26362 -93 2 7.13832 10.0279 17.0488 0.309364 15.3336 -19.7914 -94 1 11.0163 0.890853 5.00632 -3.98909 -12.3472 3.8442 -95 2 10.8807 1.76939 4.61668 6.53092 -8.55309 -4.92776 -96 2 10.738 0.225438 4.34173 2.35985 18.608 2.04389 -97 1 4.21667 2.95093 13.149 10.2014 -19.1015 31.4776 -98 2 4.53515 3.41914 13.9504 -8.71013 -4.86526 -13.316 -99 2 4.15898 1.99936 13.4513 -0.534052 25.4454 -15.6313 -100 1 8.50322 10.2612 1.79208 -4.34668 -17.3092 21.2914 -101 2 8.27549 10.8526 2.5321 5.30441 -1.44182 -6.44774 -102 2 8.58493 9.36982 2.21324 2.85947 21.4101 -9.02924 -103 1 10.3161 1.69184 15.4745 -6.1912 0.342966 -7.58309 -104 2 11.1781 1.38278 15.7166 17.9205 -0.758309 5.87707 -105 2 10.347 1.84648 14.5196 -5.50104 2.18071 3.0962 -106 1 2.60936 12.9662 7.92592 -2.1007 2.96569 -8.82009 -107 2 3.10883 13.7131 7.55922 1.74385 -4.33572 0.675454 -108 2 1.96491 12.7329 7.23617 6.25685 -1.04193 4.90183 -109 1 3.83706 11.6816 4.96058 -22.5573 -14.4893 8.95363 -110 2 3.56827 11.1846 5.76493 10.0033 8.11351 -16.9036 -111 2 3.08816 11.5736 4.33469 10.7007 11.5305 11.906 -112 1 6.6582 14.5337 16.9912 3.19916 -10.5164 -7.18554 -113 2 7.36558 15.1576 17.1605 2.12516 -0.469731 1.77687 -114 2 6.47854 14.5937 16.0445 -2.82585 4.49818 1.60201 -115 1 14.2037 14.4903 3.21857 16.956 -7.57282 -16.8086 -116 2 13.9492 15.374 3.44691 -9.21692 15.261 -0.929302 -117 2 13.8764 13.9351 3.91269 -8.69982 -10.6193 13.7942 -118 1 8.69855 18.0357 16.1264 41.5507 -6.08144 10.5978 -119 2 9.33855 17.4056 16.5195 -30.3672 -5.67283 -6.86348 -120 2 9.34419 0.0405339 15.8183 -19.2067 16.0047 -5.03817 -121 1 4.69307 1.79842 4.89677 16.2385 30.5389 -26.6001 -122 2 3.80396 2.19318 4.80489 14.8244 -2.46841 6.40587 -123 2 5.29999 2.32882 4.27745 -28.5893 -25.5208 24.7929 -124 1 15.0277 12.5795 16.5521 32.6678 1.07726 26.51 -125 2 14.723 12.7481 17.4682 -6.07814 3.10734 -21.8061 -126 2 14.3421 12.5499 15.8992 -22.7964 0.862239 -7.92322 -127 1 15.7044 18.5089 16.8468 26.9219 -3.0014 45.6431 -128 2 16.268 18.6119 17.6883 -20.0241 -2.05323 -42.0683 -129 2 15.5234 17.5608 16.7959 -6.5303 3.1055 -1.70461 -130 1 1.37672 1.34924 16.652 -10.0314 2.12664 3.94932 -131 2 2.13238 1.94076 16.8287 -14.5592 -12.7899 -0.0819953 -132 2 0.657997 1.59844 17.2733 17.8805 -0.89879 -9.33461 -133 1 18.2331 4.34642 15.9005 -0.884234 -3.04582 -21.1642 -134 2 17.8346 3.73179 15.2509 9.01129 10.3034 11.7071 -135 2 0.449037 4.61451 15.5361 -9.49368 -5.77709 6.1071 -136 1 12.1007 17.0847 16.1341 -21.8736 -13.8645 50.4236 -137 2 11.3773 16.6353 16.6829 29.7152 15.2039 -30.2146 -138 2 11.8045 17.1565 15.2358 -4.92233 -3.24187 -16.5992 -139 1 16.1203 2.66556 18.245 -33.6191 11.8512 -24.8852 -140 2 15.5683 3.39571 18.6154 19.5646 -10.4389 -9.45588 -141 2 15.8602 2.60471 17.2935 4.4965 0.524143 22.3318 -142 1 6.68711 13.7575 10.0686 6.57394 0.780895 15.4701 -143 2 6.65896 13.3749 10.963 -3.37269 2.77311 -6.77332 -144 2 6.71723 13.0193 9.46247 -3.0919 -8.05072 -6.49535 -145 1 10.1832 18.4638 2.68288 15.4984 11.1175 -14.1442 -146 2 10.4797 0.410785 1.94548 -7.56539 -13.8801 19.3089 -147 2 9.29042 18.2071 2.48382 -12.5464 -2.66261 -5.58966 -148 1 3.06565 17.654 6.19973 -11.4817 2.82915 -15.5316 -149 2 2.17867 17.6912 5.79869 7.15707 -3.68965 15.0105 -150 2 3.60434 17.7569 5.40979 11.429 -4.57556 5.13078 -151 1 12.6359 16.7831 7.87678 -34.4323 5.42099 5.88286 -152 2 11.8215 16.2589 7.70694 19.4452 0.972157 -0.554869 -153 2 12.3283 17.4377 8.53506 12.9634 -4.48143 -6.06952 -154 1 14.8812 15.2555 8.26349 -9.13488 6.23831 13.721 -155 2 14.2179 15.9485 8.09528 6.25869 -7.42326 0.874894 -156 2 15.4123 15.1764 7.46942 0.572987 8.13089 -2.89012 -157 1 17.8363 18.2748 0.235726 -36.9104 2.14965 -2.72595 -158 2 18.5544 17.6878 0.132306 25.4932 -25.6882 -8.95291 -159 2 18.2375 0.371142 0.648791 5.78715 27.9621 12.2792 -160 1 0.76648 10.5228 1.42349 -23.6052 -44.6853 36.9297 -161 2 -0.0625164 10.0248 1.72181 36.7073 15.4552 -13.6362 -162 2 0.483164 11.1861 0.82966 -10.4498 25.872 -24.2739 -163 1 1.81496 12.3027 3.28068 4.06427 7.40541 18.1542 -164 2 1.38036 11.6556 2.74613 -8.62838 -16.0879 -14.4133 -165 2 2.12935 12.9782 2.6808 0.203437 6.54347 -1.70293 -166 1 0.715096 17.2857 4.99328 6.02973 16.9927 -22.851 -167 2 -0.0549074 17.8034 5.17132 -8.63108 24.1627 -3.07112 -168 2 0.561936 16.5317 5.51148 1.70853 -39.3498 23.4345 -169 1 1.0126 0.815092 9.34853 9.77893 1.05612 10.9097 -170 2 1.24172 0.537916 10.2451 4.93082 3.28815 4.21298 -171 2 0.133534 0.483606 9.24599 -18.3012 -2.93221 -7.23643 -172 1 16.7899 2.36695 13.4143 1.34336 11.0529 -24.546 -173 2 16.9036 2.71504 12.491 -0.235106 -7.90147 26.8103 -174 2 16.4417 1.47344 13.309 3.25474 -1.82726 5.59598 -175 1 2.66167 16.0077 12.0598 12.6303 -22.6944 6.71055 -176 2 3.01062 15.6298 12.8947 -8.01809 9.38789 -15.4913 -177 2 3.11281 15.5097 11.3415 -7.7677 12.8204 10.8964 -178 1 16.364 15.512 6.14932 19.0855 9.58845 -19.9598 -179 2 17.3177 15.4404 6.40388 -23.0707 9.20906 -7.80583 -180 2 16.2465 16.2844 5.52559 8.28806 -24.9431 19.8586 -181 1 5.77951 5.20043 11.8033 8.47507 -20.9263 -15.707 -182 2 5.6405 6.00993 12.2754 -6.27864 14.793 10.9641 -183 2 5.18835 4.5564 12.2066 -2.11002 -1.11499 -2.91817 -184 1 15.1794 4.92089 0.775894 -18.0102 -8.76269 31.4284 -185 2 14.9497 4.67568 1.72392 8.26683 8.97624 -32.6089 -186 2 14.3636 5.23769 0.366515 4.70525 -0.664057 3.69432 -187 1 16.3975 16.4382 1.83859 15.8969 -1.83249 -31.9545 -188 2 16.3175 16.7184 2.73629 -8.02889 11.6848 21.5541 -189 2 16.8259 17.1655 1.34034 -8.03244 -7.80667 10.4102 -190 1 0.153841 4.83744 3.963 18.3567 41.8245 -8.83163 -191 2 0.481764 5.78512 3.86014 -17.0028 -34.1388 7.97498 -192 2 0.952119 4.32423 4.11352 -0.77715 -2.59924 4.82879 -193 1 2.94647 15.0748 15.1079 -17.5423 -9.74792 39.2804 -194 2 2.84668 14.6538 16.0052 7.88621 4.55617 -28.9019 -195 2 2.37581 15.8415 15.2342 5.36547 9.02165 -11.4736 -196 1 1.04118 14.6398 9.41517 21.0794 -20.4815 -17.0137 -197 2 1.63478 13.9208 9.06194 -19.3512 25.5288 8.96267 -198 2 0.7851 14.3144 10.2695 -7.28135 -4.68142 11.1743 -199 1 13.5343 16.512 11.5541 0.415781 17.9887 -13.1724 -200 2 13.2087 17.3014 11.0493 5.42519 -19.6136 10.4452 -201 2 13.1525 15.7431 11.1062 -5.37134 4.1326 5.42785 -202 1 4.79073 1.57335 0.678685 -10.2425 -16.6589 -0.602312 -203 2 4.2243 2.02466 0.0269211 5.06007 -3.50169 9.95598 -204 2 4.26355 0.829094 1.04695 5.40097 16.8315 -2.73739 -205 1 1.55169 18.6011 11.9401 -14.2618 14.3088 -13.4455 -206 2 1.54559 0.423493 12.7773 -0.760074 5.21042 2.72529 -207 2 2.10509 17.8447 12.0596 11.7149 -17.0814 4.30068 -208 1 11.3926 10.0859 4.15406 35.1149 20.4659 -18.5884 -209 2 11.4922 10.6036 3.30306 -8.07316 -21.3073 26.3838 -210 2 12.3257 9.94393 4.45754 -25.8381 1.71308 -8.95455 -211 1 8.18732 12.2257 3.75704 -12.727 -0.351394 27.2441 -212 2 9.08394 12.5468 4.00553 -19.5779 -3.96369 2.83586 -213 2 7.55786 12.2705 4.55735 35.1927 2.13842 -31.3906 -214 1 14.6183 4.0143 3.36201 13.432 11.2186 16.7224 -215 2 15.2472 4.27703 4.07585 -12.4329 -9.47893 -15.9273 -216 2 13.7521 4.30159 3.67007 -0.91716 0.860244 -2.07153 -217 1 5.73358 1.67843 7.60794 -24.3615 -22.8066 38.6551 -218 2 5.03202 1.06037 7.9982 26.7251 29.011 -15.8684 -219 2 5.4689 1.83957 6.71483 -6.40801 -4.86943 -26.9957 -220 1 17.8709 0.966847 4.84319 9.19834 18.9135 -13.8104 -221 2 18.365 1.30942 4.06688 -7.16187 -11.4028 13.2983 -222 2 17.8528 1.72071 5.45189 -4.56365 -9.98849 0.137087 -223 1 6.8232 9.21412 4.53503 0.0591715 -6.07859 -16.7729 -224 2 6.61803 9.33533 5.45725 2.71524 4.28405 13.1117 -225 2 7.76963 9.02928 4.48077 0.0640272 -1.66157 1.55662 -226 1 2.43776 14.707 2.05519 12.3789 -12.7502 -17.0618 -227 2 3.26162 14.6424 2.56361 -5.44595 2.48516 -0.426941 -228 2 2.66563 14.4192 1.14611 -3.66427 9.22898 15.3942 -229 1 17.2291 12.9271 13.0675 -25.7945 34.5425 2.40746 -230 2 16.3582 13.328 13.3279 21.6203 -16.0155 -5.62376 -231 2 17.7378 13.7209 12.8173 -0.837652 -12.191 -0.563337 -232 1 14.8245 10.5613 1.47762 -19.5687 -28.1113 -12.7998 -233 2 15.3117 11.2776 1.82539 19.2978 30.1093 14.6064 -234 2 13.9052 10.723 1.70642 0.475408 2.13461 -1.67485 -235 1 5.64982 6.63563 4.55084 7.38671 -15.2963 15.0755 -236 2 5.89214 7.54949 4.44479 2.16454 16.7651 -4.4857 -237 2 6.3044 6.30345 5.19757 -6.24708 1.07556 -9.93912 -238 1 8.10845 8.3271 10.3627 -2.57156 5.78827 13.3728 -239 2 8.61892 8.85799 9.7482 5.06505 3.86155 0.738683 -240 2 7.30116 8.09886 9.91192 -6.7312 -10.1116 -10.9746 -241 1 13.4488 18.4608 5.65963 -13.3307 -19.6223 8.99938 -242 2 12.6096 0.239632 5.39678 7.81848 3.10411 6.37483 -243 2 13.1935 17.7385 6.2846 5.11891 19.4349 -8.45882 -244 1 -0.00278136 2.5625 0.408955 -12.183 35.1922 -19.112 -245 2 17.7147 2.60224 18.7259 18.9642 -9.11891 12.7486 -246 2 0.290302 3.48872 0.227759 6.22068 -26.2608 7.60118 -247 1 12.9842 10.8497 9.70117 -72.6257 27.1129 -13.2266 -248 2 11.97 10.965 9.69449 48.4921 6.31007 0.109369 -249 2 13.0048 9.91956 9.83068 16.3628 -25.292 6.36111 -250 1 0.548273 12.2593 11.2103 29.2233 3.63314 -8.31727 -251 2 18.2651 12.1894 11.4198 -11.8267 3.42799 7.99272 -252 2 1.06577 12.5175 11.9926 -12.6507 -2.71608 -2.06856 -253 1 5.24515 7.35168 13.3154 -11.9716 -5.94003 -7.6844 -254 2 5.73604 8.07931 12.9223 2.64227 5.43904 4.60776 -255 2 5.63818 7.16239 14.1672 7.7875 0.124539 4.29694 -256 1 1.16856 6.76355 12.0035 -37.5881 -40.6251 -19.8542 -257 2 0.334741 7.08942 11.6206 8.86965 -4.87383 5.4559 -258 2 1.63397 7.52151 12.2381 28.649 45.7996 14.9133 -259 1 15.5501 9.75639 12.3967 -1.92883 21.1886 15.8166 -260 2 15.1116 10.6344 12.221 21.3449 -31.3991 6.12972 -261 2 16.0605 9.85526 13.2245 -13.7753 0.465455 -14.4819 -262 1 16.5858 12.6354 5.59083 -2.62715 14.8355 -19.0185 -263 2 16.4437 13.5882 5.83081 0.436603 -22.1434 -16.2318 -264 2 16.416 12.5171 4.60718 5.48378 12.0784 33.3147 -265 1 6.40279 9.86277 0.0794915 -20.3924 -8.41649 -9.56759 -266 2 5.55524 10.218 0.380594 4.23452 2.32222 -1.66862 -267 2 7.0555 10.2042 0.674211 16.128 4.48978 14.4774 -268 1 12.2427 6.01171 4.00399 -23.1281 -36.6346 24.2315 -269 2 12.2798 6.64894 3.31747 0.117026 23.2517 -16.0656 -270 2 11.2984 5.74139 4.08171 19.6095 7.84283 -4.73597 -271 1 0.360057 12.9056 0.031807 -8.11921 2.1908 5.08387 -272 2 18.8977 13.4796 0.805411 -3.72305 -1.59029 -3.55744 -273 2 18.3786 13.2516 18.0169 7.85083 -4.92073 3.80969 -274 1 3.55677 18.7152 8.66247 19.9063 -6.335 -5.44295 -275 2 3.49677 18.1902 7.8473 -5.97778 6.84736 4.02201 -276 2 2.66917 0.348355 8.87781 -8.06089 0.921211 -3.36616 -277 1 7.26214 17.4262 4.43744 19.2672 26.0801 -3.30237 -278 2 7.75433 18.2474 4.74147 -22.4281 -27.0983 -14.818 -279 2 7.37471 17.3728 3.46226 -1.25032 2.03681 18.5343 -280 1 9.25258 17.1703 12.1759 28.8617 -14.1678 9.07352 -281 2 9.26958 16.3393 11.6513 -2.57153 16.4076 7.11435 -282 2 10.1283 17.1978 12.6604 -29.6357 0.448077 -14.593 -283 1 13.2677 13.193 7.99719 -21.1722 -32.5843 10.0566 -284 2 13.3388 12.6042 8.77917 0.104276 5.764 -17.169 -285 2 13.8077 13.9427 8.17139 23.4211 18.1414 5.93605 -286 1 14.7593 2.91325 15.4943 24.3728 -2.49696 -23.5999 -287 2 14.0361 2.3713 15.1546 2.238 -3.60609 4.01929 -288 2 15.4274 2.94021 14.7667 -15.6113 -2.56038 15.0831 -289 1 9.9738 15.6484 16.9671 -8.54083 0.59912 -5.05632 -290 2 10.1057 14.7848 16.5569 10.1368 1.85589 1.18764 -291 2 9.46144 15.457 17.7506 -1.80616 -1.66933 10.9911 -292 1 11.2344 8.55758 16.6355 7.77426 1.92795 -6.45244 -293 2 10.4646 8.11257 16.295 -8.96701 -9.58703 -5.10609 -294 2 11.6991 7.91388 17.1598 3.61158 -8.68538 8.99751 -295 1 4.14955 18.3179 16.8036 -6.71252 9.00681 -6.36217 -296 2 4.47312 17.6803 17.4466 6.33314 0.74429 2.85153 -297 2 4.24503 0.569095 17.1648 -0.42517 -11.8307 0.148866 -298 1 2.33957 4.29184 8.91302 22.2448 -7.34702 27.8454 -299 2 3.30686 4.08394 8.81247 -29.123 7.66299 4.05924 -300 2 2.12598 4.16624 9.8839 8.54186 0.354435 -34.7065 -301 1 9.95255 10.4179 9.8571 -18.8164 27.0404 -12.2944 -302 2 9.4534 11.1894 9.4744 17.3372 -21.5482 9.10503 -303 2 9.8309 10.4683 10.8129 6.92766 -2.76642 -0.156957 -304 1 9.80127 0.922938 10.8108 4.3272 3.59983 6.04006 -305 2 9.35046 0.175669 11.2139 0.840012 -6.18623 1.13214 -306 2 9.1369 1.38463 10.2905 0.460774 -0.831922 -5.90435 -307 1 9.16459 15.1765 10.2101 -26.8722 -7.06493 -21.2153 -308 2 8.97785 15.8968 9.57551 3.0406 -6.31351 13.2231 -309 2 8.39419 14.5643 10.0571 23.5779 16.7742 11.4525 -310 1 0.773683 9.7544 10.1833 18.261 11.1305 -23.2394 -311 2 0.868202 10.7262 10.3345 -3.82315 -24.612 -0.100636 -312 2 1.30536 9.53677 9.37727 -17.4146 8.84667 24.1623 -313 1 17.2096 4.87642 8.04469 -12.9959 -9.21067 35.1395 -314 2 16.3347 5.16277 8.3943 19.7751 -0.094318 -9.55648 -315 2 17.6197 4.3572 8.78272 -10.3132 11.9302 -24.4143 -316 1 14.8095 14.6496 0.0373288 -5.69372 -9.04424 21.9283 -317 2 15.5101 14.9524 0.640087 -10.906 0.748239 -2.66247 -318 2 14.0769 14.3265 0.613297 14.425 8.36295 -12.6903 -319 1 3.89537 11.0996 9.55593 -9.82967 16.3938 -0.398364 -320 2 3.93242 11.2996 10.5001 -1.21387 -1.78602 1.5381 -321 2 3.39392 11.8407 9.15947 5.2768 -13.1919 0.569667 -322 1 11.4169 10.7371 1.49225 5.47317 24.4145 -6.81884 -323 2 11.5532 11.6314 1.08329 0.074839 -23.6179 10.2373 -324 2 10.4618 10.6109 1.50924 -1.9569 -1.96948 -2.8184 -325 1 13.1395 7.21524 12.5729 -20.455 -7.16835 0.858137 -326 2 14.0577 7.03675 12.4308 23.1896 -1.74136 0.0778831 -327 2 12.7378 6.3322 12.608 -1.47964 6.92135 2.9072 -328 1 9.65614 1.96645 0.86496 18.1931 4.09637 20.8777 -329 2 8.84682 1.67677 0.484793 -23.8326 -3.90796 -8.97572 -330 2 10.1746 2.31935 0.150168 8.91513 5.01659 -9.40528 -331 1 10.6386 13.4197 4.53193 2.28663 -4.65747 18.8344 -332 2 11.4948 12.9639 4.69275 -16.1918 12.7288 -0.469196 -333 2 10.3958 13.8423 5.38242 9.30576 -5.17735 -13.1714 -334 1 14.5273 1.57884 10.9459 15.1221 22.4117 -0.776229 -335 2 15.362 1.31139 10.5257 -10.7732 -5.17355 3.70166 -336 2 14.6474 2.54531 11.0746 -6.11584 -12.5888 -6.32845 -337 1 14.4766 12.0159 11.6273 -10.9263 4.56586 -44.1867 -338 2 15.2047 12.4077 11.0864 -12.0042 -9.95663 15.0185 -339 2 13.8634 11.5981 10.9451 22.3117 17.3775 30.6101 -340 1 8.16847 5.14124 9.81669 -29.5484 17.7318 23.7918 -341 2 7.27475 5.12719 10.2684 30.6512 -1.40914 -16.6308 -342 2 8.33799 4.26267 9.50012 -3.06916 -18.2431 -3.24008 -343 1 1.5108 16.9662 18.5044 9.55151 26.7901 -23.2493 -344 2 1.84435 17.2897 17.6363 -7.76754 -5.77411 19.656 -345 2 1.83481 16.0826 18.5596 5.96378 -22.3257 1.76596 -346 1 1.42717 17.3886 15.3379 47.0554 -13.0927 -7.45492 -347 2 1.50543 18.1882 15.8264 3.14075 27.3625 12.617 -348 2 0.523906 17.2066 15.2924 -49.7083 -12.5335 -2.74225 -349 1 3.49173 5.73723 6.04987 -5.63889 12.5308 6.32322 -350 2 3.05134 6.46754 6.5425 11.5005 -15.9447 -9.63575 -351 2 4.14223 6.14285 5.45548 -4.8412 1.1033 3.2125 -352 1 12.5916 9.51872 14.2408 10.4293 -27.0271 -12.8548 -353 2 13.028 8.79356 13.6831 -19.628 26.0366 30.4849 -354 2 12.3513 9.14884 15.1174 6.55215 0.813797 -17.5332 -355 1 4.09544 15.2089 7.12218 31.8609 13.6269 2.32941 -356 2 3.67616 16.0257 6.80924 -1.84113 -5.17266 1.34804 -357 2 5.07546 15.4284 7.13078 -32.8392 -10.6488 -3.17146 -358 1 0.799143 8.79431 15.1488 8.21516 12.8732 -16.9375 -359 2 0.575284 9.7423 15.0796 -2.5473 -12.0602 5.3867 -360 2 1.52676 8.70151 14.5038 -8.32138 -2.51513 8.31525 -361 1 12.8725 8.28632 10.0993 13.5644 -10.3417 -12.785 -362 2 13.6812 7.81606 9.78663 -13.8637 7.80766 13.5238 -363 2 12.7502 8.10095 11.0322 6.24745 -8.27276 5.3213 -364 1 15.2423 7.98405 3.44353 15.6799 19.5655 -11.9659 -365 2 14.4463 7.83544 2.89643 5.54982 -16.2362 17.4101 -366 2 15.5184 7.39607 4.17406 -22.72 2.15229 -11.0841 -367 1 17.1687 6.76019 0.0376092 -10.314 6.5713 -12.413 -368 2 16.7239 5.93548 0.292072 -0.0664332 9.88195 -1.29815 -369 2 16.4741 7.34647 18.2846 16.8516 -16.4801 16.1304 -370 1 8.96925 6.98328 7.86383 -27.8745 -15.8066 22.0328 -371 2 9.86939 7.24269 7.81058 30.3142 9.1639 -3.03437 -372 2 8.87474 6.48936 8.713 -1.39219 10.6855 -19.1169 -373 1 12.482 0.614891 1.23015 1.92335 -8.70167 1.10105 -374 2 13.2432 1.03802 1.64803 2.06157 -2.24376 -3.30204 -375 2 12.803 0.16068 0.442821 -0.913907 6.47573 3.0001 -376 1 5.66871 15.0647 14.4598 7.14191 19.2454 -5.51099 -377 2 4.75956 15.0903 14.7907 1.11348 4.01334 -3.77227 -378 2 5.94804 16.0038 14.294 -6.0872 -24.4911 3.70117 -379 1 3.73529 6.48244 1.70347 -4.32476 7.10488 -19.4811 -380 2 3.3805 7.26573 1.22404 3.0021 -10.505 14.7125 -381 2 3.73285 6.71028 2.6365 -0.71904 4.06656 1.73817 -382 1 3.86925 11.322 12.3296 2.55777 5.65869 0.326193 -383 2 4.7048 11.7602 12.5386 0.0734552 -4.93202 -1.70743 -384 2 3.20028 11.8652 12.7549 -2.96009 3.18005 0.676376 -385 1 5.3196 3.88545 15.7107 -12.565 72.4648 14.1271 -386 2 6.00107 3.31 15.4478 35.5939 -28.3589 -8.92722 -387 2 5.74724 4.80358 15.8116 -17.6513 -43.1362 -7.7855 -388 1 14.0258 10.1309 4.70784 36.378 -19.982 -23.5474 -389 2 14.2654 9.87929 5.60631 -3.02994 -1.07275 0.485782 -390 2 14.6765 9.60938 4.12831 -34.5421 20.7478 23.7761 -391 1 7.50853 17.298 8.98976 4.28677 22.6193 13.4416 -392 2 7.01472 17.6504 9.76182 0.935323 -12.9311 -15.6818 -393 2 7.87431 18.0869 8.55212 -1.49272 -9.54271 -2.09709 -394 1 4.57424 14.4015 3.77738 -1.32578 6.84514 50.6918 -395 2 4.51443 15.3073 4.2079 4.46262 -31.6709 -20.6737 -396 2 4.58351 13.7394 4.53798 -1.39317 23.0513 -31.5206 -397 1 14.2431 7.32994 15.8885 26.8814 9.55229 5.02737 -398 2 15.048 7.31796 15.3145 -19.1816 0.583054 17.9404 -399 2 14.5184 7.8184 16.7026 -8.00009 -12.2304 -19.9762 -400 1 3.00564 18.4171 1.98737 1.19435 35.3283 33.2576 -401 2 2.60973 17.9491 1.28647 -18.7059 -24.7202 -27.1582 -402 2 2.28625 0.311703 2.39571 15.2164 -11.2621 -13.5372 -403 1 7.97098 1.60459 4.54116 29.2267 3.13781 -13.0843 -404 2 7.39603 1.96083 3.86318 -8.15365 2.40339 -0.697123 -405 2 8.86388 1.74438 4.1564 -17.9094 -5.03071 12.9608 -406 1 2.50155 14.1648 17.7228 -14.4362 -20.2086 14.4505 -407 2 1.80023 13.5192 18.0233 22.5798 22.6486 -13.5864 -408 2 3.34474 13.7188 17.8802 2.38023 -0.79805 1.89101 -409 1 0.962462 1.97628 13.8796 24.0866 5.42438 -18.2963 -410 2 1.23331 1.73159 14.7528 2.00372 -3.67266 20.967 -411 2 0.0219615 1.96156 13.879 -26.3344 -0.788872 -2.58417 -412 1 4.34962 0.156713 13.8729 25.4477 -1.51409 -1.97896 -413 2 5.30295 18.5478 13.9084 -21.2168 3.6137 -4.76321 -414 2 3.99528 18.4902 14.7051 -3.29088 -0.042535 8.53213 -415 1 7.35889 1.01117 18.4602 -20.0845 2.29217 31.534 -416 2 7.53777 0.614221 17.6282 1.02155 -13.8743 -28.1328 -417 2 6.39885 0.929085 18.6632 17.4429 7.83311 -8.37388 -418 1 15.8463 18.3909 13.9448 -43.3072 10.6601 -1.92517 -419 2 14.916 18.6906 13.7723 29.0574 -10.6436 -1.66619 -420 2 15.8257 -0.445507 14.8871 10.2412 6.45473 0.424587 -421 1 10.2808 4.63783 16.2194 -42.4572 -26.934 -19.6441 -422 2 11.2059 4.65809 16.3645 33.0638 0.71496 4.62375 -423 2 10.0964 3.70704 15.9214 4.59595 26.5122 11.6188 -424 1 15.903 17.6519 4.47823 -22.6026 32.3058 18.5214 -425 2 16.5145 18.4189 4.46111 -7.58873 -12.9749 2.84853 -426 2 15.0701 18.0221 4.91498 30.26 -18.095 -22.6862 -427 1 6.91987 17.5654 13.9309 41.5981 2.12242 13.325 -428 2 7.49428 17.7119 14.7497 -22.2257 -6.74767 -31.4029 -429 2 7.56851 17.4237 13.1898 -17.2813 4.26485 21.283 -430 1 13.2143 6.40362 6.52296 -17.8609 -7.45559 2.6451 -431 2 14.0836 6.75111 6.37132 17.2928 3.48546 -1.85822 -432 2 12.8363 6.25317 5.64277 2.90235 4.29902 5.97585 -433 1 7.86013 2.26394 9.49062 -8.36252 -9.46169 -35.4407 -434 2 7.29684 2.1706 10.2513 -11.7917 -0.851936 13.7299 -435 2 7.34714 1.87564 8.72892 15.7155 15.0955 20.8405 -436 1 15.1343 14.8378 13.7575 -15.8142 13.0315 4.83039 -437 2 14.8532 15.0481 14.6708 3.35379 -3.45087 -12.098 -438 2 14.5629 15.3828 13.1802 11.493 -9.40285 7.27009 -439 1 9.38118 8.39884 3.83519 4.0123 -7.74443 -2.87465 -440 2 10.2467 8.83344 3.97294 -13.6344 -10.1795 -2.34121 -441 2 9.51993 7.43201 3.84247 0.270426 14.3255 0.324032 -442 1 17.6982 13.5806 16.4882 -11.1823 29.4115 -15.1875 -443 2 16.7477 13.4163 16.452 -1.16521 -4.14372 2.83933 -444 2 17.7994 14.4458 16.0124 3.95943 -25.1425 10.6502 -445 1 4.93057 10.3937 2.82949 21.3493 0.31084 -7.87351 -446 2 5.82872 10.0425 3.0149 -20.5327 4.11374 3.5741 -447 2 4.70497 10.9363 3.59521 3.63155 -1.89772 -0.291932 -448 1 3.65557 8.40975 9.92882 -7.92631 -13.4411 16.4299 -449 2 3.66668 9.34394 9.72247 1.00161 8.70404 1.26029 -450 2 3.36367 8.33438 10.8592 4.36465 5.8519 -13.4993 -451 1 15.9508 6.91708 5.85912 26.4071 -7.62551 -3.83966 -452 2 16.729 7.34279 6.26867 -14.5536 -3.6129 -4.6023 -453 2 16.2929 6.05819 5.53033 -12.7649 13.2481 9.54942 -454 1 15.2478 7.26488 8.9948 -11.5397 21.0457 -23.7706 -455 2 16.0349 7.57374 9.47019 -5.83 4.16597 -2.61919 -456 2 14.9977 7.92652 8.27445 16.2337 -23.38 28.7542 -457 1 6.17715 12.7863 12.74 7.06624 23.8889 14.8517 -458 2 6.98998 12.4152 13.1111 -3.934 -5.41615 -1.6338 -459 2 6.02064 13.6181 13.2483 1.6805 -16.267 -10.1818 -460 1 12.1255 4.53395 13.1266 36.5984 28.8141 18.352 -461 2 12.1988 4.68857 14.088 4.72218 -0.985297 -9.83354 -462 2 11.344 4.04995 13.0228 -42.0246 -23.4808 -8.79261 -463 1 11.4542 8.08345 7.86287 23.2187 -10.867 14.4494 -464 2 12.2022 7.55078 7.50013 -20.6002 10.1652 -0.104446 -465 2 11.6749 8.16233 8.821 -5.77941 1.62242 -23.2927 -466 1 16.9966 10.8 7.60022 14.0465 -17.3895 -10.8701 -467 2 17.6655 10.1188 7.31004 -18.6815 22.6831 6.1404 -468 2 16.8855 11.476 6.90625 3.56282 -12.242 0.823841 -469 1 5.28409 18.0615 10.7272 -25.4136 -4.73004 -4.09376 -470 2 4.85025 17.4105 11.3211 10.0924 14.2936 -14.0097 -471 2 4.61921 18.235 10.0106 18.3134 -6.11244 18.1083 -472 1 7.63344 17.4775 1.60819 -12.3126 -2.35291 35.094 -473 2 8.06049 16.702 1.26786 10.3266 -12.472 -14.3961 -474 2 7.64482 18.174 0.971148 2.96613 14.6858 -21.2308 -475 1 1.92556 12.9088 13.6099 -6.92879 6.84011 17.0322 -476 2 1.40166 12.3078 14.1747 6.51182 9.66465 -5.96466 -477 2 2.01688 13.7519 14.1152 3.80073 -20.221 -11.3532 -478 1 9.32296 6.74742 14.7603 -6.16505 19.9578 -6.21839 -479 2 9.80961 6.04203 15.1542 10.8193 -23.4577 14.2182 -480 2 9.81429 6.97553 13.9666 -4.58884 0.0213979 -5.59057 -481 1 15.2687 4.29028 10.7744 -16.6773 -11.1812 -9.87371 -482 2 16.185 4.03181 10.6852 9.89086 1.55812 4.86514 -483 2 15.2046 4.88146 11.5266 6.28069 5.56792 1.9642 -484 1 11.3833 6.23863 0.0689293 -3.19885 -6.29427 4.65322 -485 2 11.5449 5.27036 18.7473 -10.1654 17.1623 -6.02864 -486 2 10.4171 6.41156 18.6664 16.019 -11.974 -2.10863 -487 1 18.4779 11.4738 14.9298 -4.11302 6.12113 -30.5228 -488 2 18.0937 12.0014 14.1715 8.36132 -18.8326 26.0479 -489 2 18.3027 12.0103 15.7035 0.536699 7.83234 4.13522 -490 1 7.03799 9.27423 7.33397 -11.8444 -18.9096 15.35 -491 2 6.61404 8.50211 7.787 12.2323 17.6714 -16.3801 -492 2 7.97664 9.07639 7.31215 4.33333 -2.45816 -2.54611 -493 1 18.3885 15.3347 12.1965 11.3664 3.9942 -3.56245 -494 2 0.676524 15.5664 11.9851 -14.9026 2.39255 4.26485 -495 2 17.8062 15.8491 11.6143 4.55299 -1.04774 1.98359 -496 1 16.551 4.342 5.30396 -29.3567 -2.30965 40.8017 -497 2 16.5003 4.35995 6.30392 8.99046 -4.55546 -31.3189 -498 2 17.4312 4.58446 5.06774 26.2551 1.0485 -9.7407 -499 1 17.7614 3.18175 10.7726 14.454 -1.68376 5.55906 -500 2 18.6848 3.25815 11.0867 -17.2868 6.635 -4.74284 -501 2 17.731 2.30667 10.3896 -4.78084 -7.5669 -7.23363 -502 1 12.3288 18.6185 10.0887 4.81564 48.0444 9.66027 -503 2 11.5224 0.4701 10.402 18.5752 -22.9317 -12.6203 -504 2 13.04 0.683861 10.1001 -20.831 -28.6711 -0.571217 -505 1 10.4023 9.75891 12.5069 9.56908 10.7357 22.5843 -506 2 11.0968 9.84844 13.1991 -9.82495 1.00858 -15.0243 -507 2 10.3005 8.81694 12.4067 -0.389825 -11.0581 -5.16736 -508 1 0.728244 2.62509 7.20528 10.511 21.9286 8.67284 -509 2 1.10851 3.44304 7.59367 -9.47208 -14.047 -5.98037 -510 2 0.946108 1.9669 7.86838 0.119732 -6.07738 -1.41007 -511 1 0.301432 15.3195 6.88989 15.9737 -48.0831 -14.5816 -512 2 0.502768 15.5752 7.7858 2.08568 -2.79341 12.7124 -513 2 0.620951 14.3521 6.81024 -17.8336 49.2232 -1.9498 -514 1 17.0496 6.91172 14.9593 8.8057 -4.67917 1.70395 -515 2 17.812 7.50707 14.8676 -6.01141 -3.19386 0.836122 -516 2 17.3983 6.09137 15.355 -4.50622 8.29661 -2.9861 -517 1 9.11865 12.5108 8.02933 -49.9881 -7.42173 -16.2711 -518 2 9.47674 11.8107 7.47486 8.95817 -5.21768 -2.38673 -519 2 8.15231 12.5395 7.74329 38.6911 2.79466 15.4325 -520 1 1.1334 1.67756 2.81686 3.27117 15.7614 -6.58164 -521 2 0.957986 2.31477 2.10151 -6.66947 -14.3695 3.78127 -522 2 1.78538 2.12055 3.36586 -0.578909 1.22693 6.40118 -523 1 4.20106 15.0562 10.0364 -13.4085 1.18971 -5.18923 -524 2 3.93003 15.0868 9.10675 3.70212 3.27773 4.96515 -525 2 5.05647 14.6363 10.0432 10.3336 -3.36269 -1.32379 -526 1 7.40784 2.22679 14.822 -4.38879 4.63456 3.27925 -527 2 7.05629 1.62422 14.1639 1.19517 -1.6595 -3.72526 -528 2 7.83793 2.94849 14.3413 -6.72155 -4.85002 1.32971 -529 1 18.3301 14.5327 2.1542 24.8671 -25.4621 4.78212 -530 2 0.57397 14.7195 2.50861 -8.4973 4.51839 -6.64425 -531 2 17.8578 15.3422 2.05909 -12.5294 22.9533 -1.13776 -532 1 10.0489 2.71902 12.9028 6.85621 -14.8278 -12.6664 -533 2 9.96638 2.08865 12.1549 1.47254 10.1846 11.5218 -534 2 9.24995 3.25129 12.8895 -2.74325 3.95657 -0.856162 -535 1 2.95855 8.84401 12.9769 -19.5266 -12.9618 -2.46154 -536 2 3.45638 9.64099 12.8192 4.11354 12.8609 -3.4499 -537 2 3.6113 8.17746 13.175 10.7686 -6.78904 5.39462 -538 1 3.18595 8.60313 3.78164 6.49512 -8.67182 57.5105 -539 2 3.58728 9.20701 3.1814 16.1034 15.9636 -13.6327 -540 2 3.51933 8.8716 4.70776 -18.429 -13.2453 -44.8458 -541 1 5.73851 7.25721 8.5964 -4.13987 -1.96532 11.6754 -542 2 5.69005 6.29369 8.53393 1.30439 2.87011 -1.70973 -543 2 5.04632 7.51192 9.22575 1.66035 -1.11756 -5.95213 -544 1 14.9081 1.62503 1.83745 -8.73365 -28.3512 -14.8102 -545 2 15.1675 2.29904 2.4498 2.46531 19.8996 4.15138 -546 2 15.1848 1.81402 0.924567 6.2551 4.83326 15.3454 -547 1 8.63912 15.0489 0.67096 1.85438 -3.84451 5.87273 -548 2 9.43742 14.948 1.21756 -6.6173 4.03251 -1.68679 -549 2 7.96284 14.4978 1.10066 2.22069 5.93818 -4.9944 -550 1 15.4364 1.44293 7.19944 -29.9197 -3.33934 -17.0244 -551 2 14.7125 0.994492 6.68707 24.0317 7.87524 16.0302 -552 2 15.0797 2.33705 7.33252 4.46076 -6.95989 4.74521 -553 1 4.93029 12.8913 18.4644 10.9792 1.21933 18.1223 -554 2 5.27563 12.987 0.740174 -6.01723 -1.47567 -19.726 -555 2 5.68015 13.1369 17.9044 -5.07302 3.16897 2.74711 -556 1 15.3923 8.68146 18.054 15.694 19.9465 -16.5309 -557 2 15.9315 9.21769 17.4147 -18.0717 -17.5644 15.7946 -558 2 15.1857 9.29971 0.121687 -1.56315 -2.75746 2.59172 -559 1 11.9784 3.14039 18.3403 11.1408 -7.29272 18.8649 -560 2 12.1001 2.9975 0.653392 -4.70819 -0.503108 -12.7749 -561 2 12.4778 2.40933 17.9385 -7.35096 7.48199 -3.86664 -562 1 13.1896 12.7267 5.18606 4.81883 -3.59528 0.0329893 -563 2 13.4958 11.8346 4.97314 2.3467 3.28367 -0.068752 -564 2 13.4618 12.8881 6.09814 -4.13789 -2.12194 -0.520265 -565 1 6.18108 7.13483 0.245639 -8.98659 -24.3205 -5.24363 -566 2 6.15368 8.0627 19.0493 5.02048 26.2765 -0.395042 -567 2 5.28324 6.84248 0.444666 1.40419 -2.69741 2.9636 -568 1 17.7469 15.8806 14.9091 -16.6307 4.82259 1.60218 -569 2 16.7811 16.0196 14.9781 16.1488 -1.66255 -6.01934 -570 2 17.9228 15.7652 13.9648 -0.217809 -0.705292 2.49903 -571 1 13.1074 0.925484 16.7107 3.18003 -6.63181 9.52558 -572 2 14.0398 0.701227 16.9047 -10.9319 3.14101 -7.94235 -573 2 12.6435 0.0729893 16.6565 6.11054 4.53406 -2.82687 -574 1 10.8779 14.5049 7.42771 23.1657 22.4115 -16.2389 -575 2 10.1426 13.9786 7.6854 -20.2069 -15.6201 11.4355 -576 2 11.6544 13.9411 7.50544 0.873985 -2.97227 1.69423 -577 1 17.7332 8.41688 2.16357 9.83329 25.3003 13.1733 -578 2 16.8474 8.49196 2.51389 -11.5025 -5.56634 1.51969 -579 2 17.684 7.86174 1.40275 -6.79002 -17.3841 -17.6814 -580 1 12.5241 7.78132 2.0423 -1.44154 17.0415 -14.1456 -581 2 12.3356 8.69211 1.74465 0.56853 -10.9135 10.1338 -582 2 12.0507 7.22418 1.41137 4.13261 -1.84431 -3.3422 -583 1 12.0402 14.5123 10.5082 -18.3289 -2.04433 -49.0296 -584 2 12.3885 14.3833 9.58045 -11.5085 2.39427 35.0464 -585 2 11.0712 14.6752 10.3612 24.5139 -2.29095 9.58119 -586 1 6.7433 6.75035 15.5111 8.69017 25.9379 21.8943 -587 2 7.64047 7.11596 15.2998 -22.3365 -16.355 4.27733 -588 2 6.42641 7.26782 16.2896 9.37622 -14.6905 -17.8302 -589 1 7.9604 4.42511 13.2728 28.7823 16.7879 24.018 -590 2 7.37747 4.63038 12.5661 -23.4436 4.48442 -18.6585 -591 2 8.25373 5.30295 13.5968 -1.99494 -17.578 -1.9241 -592 1 13.2943 12.2257 14.4027 3.56556 -5.33332 1.41443 -593 2 13.2861 11.2546 14.3815 -5.78887 6.10336 -0.82645 -594 2 13.6298 12.4878 13.5348 -0.194802 0.853385 3.24808 -595 1 14.4975 9.60743 7.32851 -1.81828 -22.5371 -11.9494 -596 2 15.283 10.0905 7.53237 20.8949 12.3364 4.94663 -597 2 13.7862 10.0745 7.73482 -16.3884 10.3496 13.6544 -598 1 12.6855 16.7955 3.35468 10.446 54.0378 -9.24021 -599 2 12.8247 17.4169 4.11373 -2.43161 -22.9959 -18.5255 -600 2 12.7287 17.4093 2.56008 -5.07923 -25.2307 27.5772 -601 1 0.985851 7.00227 17.3383 1.31889 9.4813 -6.51378 -602 2 0.174673 6.82729 17.8428 -2.72668 6.21708 -7.63644 -603 2 0.788987 7.63656 16.6124 1.43967 -10.9643 14.4702 -604 1 12.9703 4.85252 15.7444 36.7131 7.67865 -11.6648 -605 2 13.7444 4.28338 15.4912 -28.1266 12.6425 14.7219 -606 2 13.3848 5.73698 15.8318 -12.3641 -9.92719 -0.136909 -607 1 2.31739 3.41657 5.06312 -13.6796 12.8802 45.0615 -608 2 1.71742 3.03519 5.77756 22.5616 7.27981 -29.9715 -609 2 2.67638 4.25091 5.49055 -8.69432 -27.9074 -22.1065 -610 1 8.14626 10.9014 13.7501 23.1519 -21.2188 51.9658 -611 2 8.18961 10.6456 14.7569 -3.14293 16.1916 -66.8861 -612 2 8.91613 10.442 13.3487 -9.38929 12.2654 3.7561 -613 1 12.9965 1.57692 13.2293 -13.236 30.2614 -33.2276 -614 2 13.5053 1.61767 12.3799 -8.92772 -10.8244 27.0208 -615 2 12.3556 2.33631 13.1194 22.5086 -26.9187 11.5847 -616 1 6.63966 13.684 2.03193 -11.5531 1.65982 24.7971 -617 2 6.01437 14.0711 2.69678 13.9712 -7.1585 -19.9778 -618 2 7.21702 13.1132 2.57076 -4.92077 5.61769 -6.96253 -619 1 15.813 6.37449 12.4855 -26.0384 -19.2076 5.56376 -620 2 16.3133 6.94665 11.9354 17.458 16.492 -16.919 -621 2 16.1081 6.5465 13.3734 10.1637 1.50607 12.5345 -622 1 16.7517 0.683836 9.54032 9.17465 -17.8268 3.86543 -623 2 16.8312 18.3701 9.76674 -11.2714 16.7378 -3.92594 -624 2 16.3182 0.76443 8.67683 0.0107679 -1.03064 0.242674 -625 1 6.19528 11.6935 8.23629 -2.98771 -55.3704 13.0415 -626 2 5.39217 11.4329 8.74625 16.1659 14.5788 -12.0119 -627 2 6.59624 10.789 8.03203 -10.8651 41.6219 1.75135 -628 1 2.78257 8.63233 0.349942 -51.0927 -6.02203 -19.4773 -629 2 2.14734 8.16991 18.3384 31.254 20.3071 31.1367 -630 2 2.20011 9.24624 0.868363 16.6862 -13.9373 -14.0055 -631 1 10.0933 10.2699 6.60791 4.69659 2.91801 -6.95173 -632 2 10.6585 9.65933 7.0984 -2.33853 -1.64778 -0.152736 -633 2 10.478 10.3114 5.71024 -7.38541 0.394324 12.3102 -634 1 6.85971 15.7454 6.78123 4.24276 8.06212 3.90305 -635 2 7.14611 16.2575 7.56121 -6.95129 -7.98507 -8.49325 -636 2 7.04221 16.3283 6.02778 -2.00154 -5.2395 1.03704 -637 1 6.5672 12.9167 5.89107 0.597921 -4.77378 -3.41809 -638 2 6.75629 13.7931 6.22612 0.282518 9.70238 2.49815 -639 2 6.16516 12.4266 6.61937 1.75727 3.9196 -1.62353 -640 1 16.7395 12.5246 9.74847 -3.06854 -10.3396 -13.3378 -641 2 16.803 11.7934 9.09918 0.0574675 11.3505 13.7779 -642 2 17.2471 13.2388 9.35461 0.0307086 0.265441 4.69208 -643 1 6.27963 2.83254 2.76143 -4.73524 -28.0523 14.6006 -644 2 6.37898 3.73989 2.5277 5.16678 22.951 -10.7112 -645 2 5.79937 2.39077 2.0523 -0.657158 4.14199 -3.99187 -646 1 10.6834 2.9997 3.2493 -4.30343 6.66703 3.45031 -647 2 10.3389 3.87773 3.47337 -2.10815 -7.43082 -2.74741 -648 2 10.1644 2.67816 2.50044 1.52937 0.706493 -1.87803 -ITEM: TIMESTEP -100 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.77244 6.59569 17.9763 -3.45079 -15.6041 -9.13306 -2 2 7.88004 6.49722 18.3444 6.65526 3.83231 -3.73646 -3 2 8.88832 5.875 17.3232 0.339998 10.7344 11.2284 -4 1 0.232197 8.43163 6.74931 6.06809 -9.75314 40.4456 -5 2 0.255717 8.25928 5.82997 0.568886 -7.03857 -37.2819 -6 2 0.690537 7.6579 7.15764 -12.6716 20.3857 -3.7924 -7 1 8.73054 0.448274 6.96197 0.757688 5.19807 -2.99354 -8 2 9.64384 0.493158 6.62895 -11.5479 0.592924 -0.0248858 -9 2 8.1978 0.998025 6.35807 9.15448 -7.13553 5.61176 -10 1 6.40593 1.75267 11.8149 38.8296 -3.08614 -8.28972 -11 2 5.81968 2.38515 12.1727 -25.8813 19.5399 13.38 -12 2 5.91601 0.958217 11.6787 -14.9693 -21.4487 -5.83463 -13 1 6.93553 5.46707 2.3717 -29.4847 3.29264 10.9289 -14 2 6.2293 5.77948 3.0367 33.3819 -5.43232 -34.2308 -15 2 6.73101 5.82483 1.47662 0.276644 1.33511 28.97 -16 1 16.2706 10.1725 16.0328 16.576 -12.0275 -13.9735 -17 2 17.1689 10.3287 15.6909 -13.6837 1.56601 5.28727 -18 2 15.9002 11.0264 16.2303 -5.40144 13.1923 2.47446 -19 1 10.8573 14.9713 2.3127 -4.53536 -0.807355 -13.4682 -20 2 10.8458 14.5197 3.15612 -3.95698 -5.41896 6.20362 -21 2 11.2908 15.8056 2.48855 3.23834 4.77246 6.19277 -22 1 17.2232 8.21136 11.0033 2.73792 2.45641 -7.11401 -23 2 16.6726 8.88418 11.4331 2.86084 -2.93597 -0.581414 -24 2 17.9525 8.69866 10.5809 -6.6523 -2.55116 4.88578 -25 1 14.5937 16.0509 16.2923 16.8919 1.55785 -12.0612 -26 2 13.6919 16.3738 16.3176 -7.99874 0.738503 2.77307 -27 2 14.7362 15.4806 17.0483 -6.38665 -4.70858 10.3974 -28 1 12.1782 13.2488 0.556058 -6.41896 9.17153 -4.9038 -29 2 11.8393 13.4134 18.3136 3.64438 -6.73296 -6.87976 -30 2 11.6781 13.8768 1.08938 4.30308 -0.940018 9.70193 -31 1 9.32636 5.50189 3.85673 -23.6707 -6.9557 11.6523 -32 2 8.85207 5.35955 4.73387 10.6863 3.91607 -36.7024 -33 2 8.65492 5.41152 3.1282 11.356 3.18621 25.5004 -34 1 1.53424 3.89903 11.544 -4.66799 23.5976 14.1629 -35 2 1.33558 4.79151 11.9229 9.77101 -18.0042 -9.49869 -36 2 1.78943 3.33535 12.2834 2.68741 0.460061 1.88957 -37 1 2.11036 6.99869 8.11066 2.48315 -17.2899 2.96853 -38 2 2.57184 7.49315 8.78305 3.29023 12.1045 5.89357 -39 2 2.1177 6.10606 8.48449 -3.4025 -1.3508 -8.01694 -40 1 5.18347 4.46977 7.78792 -2.57538 4.03359 -5.12796 -41 2 5.37117 3.51932 7.65443 -4.82345 11.4027 -0.558597 -42 2 4.53495 4.79047 7.12216 11.4175 -13.4448 8.55636 -43 1 3.42716 2.88114 17.3924 1.12201 37.8538 -2.09818 -44 2 4.03218 3.21565 16.6954 -8.80258 -2.8612 13.6459 -45 2 2.96175 3.68375 17.7714 12.3959 -28.5801 -12.8282 -46 1 7.56049 5.45137 6.19682 -11.2764 11.7759 39.3451 -47 2 8.17338 6.02323 6.733 -17.9712 -15.9787 -15.2388 -48 2 6.83707 5.19934 6.84169 25.8687 -1.03041 -23.6459 -49 1 9.81873 7.03274 12.0818 18.6926 1.80354 21.1658 -50 2 10.1168 6.17447 11.801 2.37707 -8.57843 -5.75387 -51 2 9.13705 7.28384 11.4839 -21.9155 5.9942 -18.2818 -52 1 13.9782 3.81734 8.11005 -6.38125 -7.14222 -11.0636 -53 2 13.4268 4.53125 7.77431 4.97705 1.71109 -4.47031 -54 2 14.3288 4.12395 8.93436 6.50574 7.00298 17.9277 -55 1 4.54162 17.1358 3.87887 10.9044 35.7056 -0.341992 -56 2 5.36932 17.5648 4.19271 -11.2647 -17.0231 -6.60056 -57 2 4.14672 17.8103 3.27983 -0.0256371 -21.9717 9.98561 -58 1 16.2123 16.5489 10.6095 26.1835 -5.76397 -19.4616 -59 2 15.4589 16.7003 11.1416 -23.8325 7.35421 23.2226 -60 2 15.8886 15.8767 10.0022 2.98718 1.98497 -7.14015 -61 1 1.93449 4.79928 0.00082377 17.3961 -4.98991 5.57961 -62 2 2.67896 5.07161 0.592242 -22.0191 7.26131 -10.4701 -63 2 1.68005 5.53286 18.0583 5.78187 -2.17332 10.5029 -64 1 11.1761 13.3033 16.4476 20.6858 -29.5101 -20.5449 -65 2 10.7502 12.4348 16.5818 -0.505604 15.8506 2.04497 -66 2 11.8189 13.0874 15.7254 -14.483 14.0049 15.9552 -67 1 10.0082 10.9133 16.7377 -9.76065 -12.5647 6.43928 -68 2 10.4104 10.0696 17.0143 -3.0625 14.8211 -5.5238 -69 2 9.04798 10.758 16.6751 14.6534 4.77532 0.819581 -70 1 11.8926 17.5507 13.5059 -15.5524 -14.4544 -0.25773 -71 2 12.4585 17.1847 12.8152 4.41482 5.53476 3.60851 -72 2 11.9755 18.5016 13.5139 9.00416 11.9454 -7.12981 -73 1 6.39659 9.54323 12.3526 -12.6063 6.46711 4.93213 -74 2 6.97402 9.29797 11.635 9.25294 -5.21247 -6.5221 -75 2 6.9248 10.0607 12.9773 -1.49192 -5.83682 -8.37915 -76 1 16.2827 12.8664 2.8283 0.430065 -24.2056 0.300325 -77 2 17.1271 13.2094 2.55074 10.9303 3.80489 0.0707423 -78 2 15.7284 13.6342 2.87288 -15.0446 12.1841 2.12753 -79 1 0.782434 12.8185 5.85612 -33.4557 3.27495 -26.778 -80 2 1.12737 12.9122 4.94214 -3.16706 -8.15793 13.9432 -81 2 18.4302 12.7528 5.74133 33.3816 -1.67566 5.80796 -82 1 5.29416 16.3645 18.462 -0.365113 -1.85929 1.37874 -83 2 5.65117 15.5929 17.9841 -1.41418 12.24 9.00358 -84 2 5.90904 16.5787 0.535619 -2.78951 -3.81837 -4.76209 -85 1 0.717617 7.68269 4.16298 45.78 12.5398 -25.9452 -86 2 0.140595 7.95484 3.42088 10.68 -3.85526 14.32 -87 2 1.67421 7.98176 3.89702 -61.12 -15.169 17.2669 -88 1 3.20538 9.16537 6.53153 -16.7997 -26.3462 11.633 -89 2 3.63886 8.66012 7.25517 -10.7634 14.1338 -16.8685 -90 2 2.28456 8.785 6.4428 29.8979 17.6904 5.8263 -91 1 7.3492 10.4558 16.1821 -32.1717 -5.51262 30.2531 -92 2 6.6595 11.1272 16.0448 13.9154 -6.26319 -1.99334 -93 2 7.03952 9.99344 16.9918 7.69449 10.9592 -10.5833 -94 1 10.9926 0.857119 5.02234 -5.32556 5.69944 -21.4369 -95 2 11.0071 1.72344 4.58448 5.20867 -2.07691 11.6276 -96 2 10.6449 0.320945 4.28448 4.96755 -3.65716 14.4683 -97 1 4.17972 2.99732 13.1563 8.08367 -30.8511 5.02994 -98 2 4.53886 3.3528 13.9956 -8.94088 -10.2248 -10.148 -99 2 4.12323 1.98418 13.2207 2.50903 42.0947 6.54014 -100 1 8.52337 10.2728 1.80778 10.3789 -10.908 24.8689 -101 2 8.43412 10.9106 2.54849 -2.4679 -8.46295 -11.8092 -102 2 8.72683 9.4118 2.24878 -4.48166 20.4458 -7.62428 -103 1 10.3146 1.66303 15.4651 0.0280032 6.46587 3.16016 -104 2 11.2365 1.5769 15.7049 7.71736 -2.87845 -0.628854 -105 2 10.2832 2.03916 14.5766 -0.873711 -2.30994 -1.44208 -106 1 2.60872 12.9688 7.93078 -1.0685 2.90827 1.70102 -107 2 3.08524 13.7852 7.70925 1.81136 -8.54773 -5.41906 -108 2 2.07592 12.7429 7.1537 2.1601 3.22826 4.8584 -109 1 3.84139 11.714 4.98357 -9.2182 -6.48315 2.00023 -110 2 3.59649 11.1336 5.73363 3.13206 7.92599 -15.0555 -111 2 3.08391 11.75 4.36582 7.48234 -0.753218 11.1676 -112 1 6.65636 14.539 16.9808 1.14971 -3.74934 -0.345026 -113 2 7.45699 15.0461 17.1534 0.734042 -3.82079 -1.22553 -114 2 6.35462 14.7758 16.0963 4.10604 -0.420587 -1.60546 -115 1 14.2186 14.4753 3.18712 8.31434 -1.03143 -11.3814 -116 2 13.7635 15.2982 3.34662 -3.59872 10.6386 -1.06184 -117 2 13.8465 13.8568 3.80574 -6.38377 -9.35153 11.7656 -118 1 8.76639 18.036 16.1575 -17.2352 -7.71273 4.18589 -119 2 9.29865 17.253 16.446 -1.99578 26.3863 -16.3924 -120 2 9.21082 0.13577 15.7005 10.7734 -16.3176 12.3305 -121 1 4.70057 1.84937 4.90583 -5.59427 22.8387 -36.2464 -122 2 3.793 2.25175 4.86575 28.8401 -10.2604 4.23254 -123 2 5.1801 2.18711 4.08016 -18.9233 -12.3263 38.2061 -124 1 15.0501 12.6021 16.5687 -12.0311 0.26828 5.88874 -125 2 14.6786 12.8761 17.4109 9.53333 3.55003 6.01908 -126 2 14.2645 12.5148 16.0221 4.98358 -1.43573 -15.5641 -127 1 15.7004 18.5129 16.8573 39.713 -3.42746 23.3516 -128 2 16.4681 18.7143 17.5055 -38.5977 -15.0096 -30.817 -129 2 15.6109 17.5396 16.7903 -2.54574 14.9499 6.02131 -130 1 1.36802 1.35817 16.6529 -7.19601 7.74866 13.6684 -131 2 2.15913 1.86948 16.876 -3.57304 -8.28302 -6.01627 -132 2 0.751389 1.61649 17.3659 4.93092 -7.13328 -12.7379 -133 1 18.2443 4.33431 15.8699 4.87602 -2.4936 -15.9817 -134 2 17.8369 3.63124 15.3424 2.32992 6.4949 4.25729 -135 2 0.452078 4.51482 15.4394 -9.42811 -2.49011 8.2103 -136 1 12.0529 17.1173 16.1421 -28.5646 -13.5401 15.8604 -137 2 11.3287 16.6705 16.6559 24.6179 11.2855 -13.6919 -138 2 11.708 17.1501 15.239 10.7504 0.848438 1.34073 -139 1 16.0751 2.69533 18.2299 -16.8426 22.7601 -19.9608 -140 2 15.7518 3.52741 18.6545 8.16925 -19.768 -14.2608 -141 2 15.768 2.75869 17.2894 6.47211 -5.43997 24.4047 -142 1 6.70105 13.7211 10.0493 -2.92253 -3.29615 13.924 -143 2 6.49616 13.3451 10.9223 2.46715 2.87816 -3.90822 -144 2 6.5701 13.0016 9.42848 5.58743 -2.71244 -4.10916 -145 1 10.1642 18.4563 2.66846 -6.4553 9.35236 -16.0973 -146 2 10.4494 0.522706 2.05557 -0.598662 -14.7868 7.93587 -147 2 9.23943 18.2921 2.43567 5.35466 0.524311 4.08806 -148 1 3.08905 17.6286 6.23363 28.1073 -1.15148 23.9606 -149 2 2.19758 17.5876 5.91536 -10.6529 4.22104 -18.8026 -150 2 3.7136 17.7221 5.50184 -12.297 -3.14114 -7.6924 -151 1 12.6187 16.7784 7.83399 -8.24743 2.38577 1.37984 -152 2 11.9273 16.0794 7.74003 7.37944 21.7069 5.85683 -153 2 12.3535 17.4638 8.48865 -0.622135 -17.7991 -6.24189 -154 1 14.8741 15.2807 8.33754 11.6667 3.93031 -5.87838 -155 2 14.2607 15.9458 8.0029 -4.6938 -2.09697 8.01324 -156 2 15.5465 15.2244 7.63778 -8.32879 0.363275 5.25782 -157 1 17.8358 18.3077 0.207666 -46.6557 3.82667 -12.4063 -158 2 18.5381 17.6928 0.20107 34.3258 -19.0599 -1.41311 -159 2 18.1099 0.429917 0.68066 12.6369 19.0779 11.4558 -160 1 0.768971 10.519 1.45234 -14.3967 -19.3664 19.1268 -161 2 -0.0407552 10.0454 1.78172 23.5075 9.70284 -14.2764 -162 2 0.503185 11.1892 0.827858 -7.10365 8.12718 -9.46819 -163 1 1.82037 12.3064 3.2607 -0.411525 2.12628 17.6018 -164 2 1.36119 11.682 2.70611 -2.67447 -10.2614 -7.1426 -165 2 2.03731 13.0482 2.69872 0.079619 5.20365 -3.96737 -166 1 0.725717 17.3003 4.98992 32.4002 3.58468 -34.9181 -167 2 -0.000639544 17.8885 5.08952 -19.7566 14.3988 12.6832 -168 2 0.713313 16.5777 5.58791 -15.4184 -21.9192 25.4801 -169 1 0.951486 0.797441 9.37101 14.826 11.188 -16.0996 -170 2 1.14791 0.588384 10.2838 -3.41112 -8.44303 11.2353 -171 2 0.0745467 0.497625 9.13864 -8.88294 -4.64793 9.22513 -172 1 16.8073 2.38946 13.4769 5.39787 -10.4284 -8.99471 -173 2 17.0506 2.69304 12.5747 -8.0967 -7.05722 13.8788 -174 2 16.5161 1.45381 13.4188 4.66162 13.0486 -2.08534 -175 1 2.62912 16.0502 12.0784 8.40953 -12.472 -10.7904 -176 2 3.04385 15.7269 12.8881 -2.37218 0.184289 -5.79457 -177 2 3.10949 15.6337 11.3228 -8.7582 6.42497 16.6586 -178 1 16.3457 15.4302 6.12389 30.9011 24.8554 -18.1041 -179 2 17.2992 15.5349 6.36757 -22.0844 -7.23183 -0.993592 -180 2 16.19 16.1865 5.50068 -1.85714 -20.6143 14.9819 -181 1 5.77873 5.21745 11.785 11.0193 -20.9315 -11.6683 -182 2 5.50793 5.92484 12.3546 -4.36629 16.5013 7.19057 -183 2 5.27867 4.45162 12.0794 -6.37659 -1.59945 -1.70387 -184 1 15.1747 4.94504 0.761547 -29.5175 -4.13494 28.6724 -185 2 14.9952 4.57194 1.67189 6.69018 16.901 -24.5633 -186 2 14.3176 5.30548 0.449447 18.0211 -8.94221 4.63226 -187 1 16.4144 16.461 1.77501 8.34865 -5.69196 -8.65308 -188 2 16.356 16.7636 2.67626 -8.71628 3.92983 13.8981 -189 2 16.7832 17.2073 1.29403 -0.614878 1.7319 -3.63708 -190 1 0.136057 4.8659 3.98965 34.6037 22.2365 -2.60366 -191 2 0.554963 5.79058 3.9624 -19.788 -38.6093 6.27627 -192 2 0.840291 4.21253 4.20207 -10.6708 20.7839 -4.14843 -193 1 2.91044 15.0804 15.1041 7.34684 -10.5058 14.2682 -194 2 2.90482 14.7198 16.034 -7.41786 16.0657 -24.8201 -195 2 2.46761 15.9418 15.099 -2.49045 -2.68752 9.6724 -196 1 0.98952 14.6361 9.40184 3.41519 -3.90395 6.55514 -197 2 1.54705 13.945 9.00075 -6.08548 3.23571 10.1521 -198 2 0.78947 14.3674 10.3125 0.535168 -4.82993 -11.1122 -199 1 13.5676 16.5089 11.5672 -19.673 9.58551 -20.9583 -200 2 13.2883 17.2623 10.9814 5.35041 -18.2182 15.9177 -201 2 13.0352 15.7491 11.2513 9.15027 7.77217 2.32965 -202 1 4.84709 1.60354 0.665871 -13.2454 -7.94988 -14.2061 -203 2 4.37724 2.10746 -0.0295305 4.1335 -5.07179 15.4313 -204 2 4.23428 0.890311 0.93575 7.29231 10.3056 3.49355 -205 1 1.57562 18.6232 11.9448 -9.54215 3.4719 -19.1533 -206 2 1.53947 0.452662 12.7669 0.622104 8.67092 13.3018 -207 2 1.94164 17.7639 12.1401 7.67295 -5.68018 1.31967 -208 1 11.3828 10.0809 4.23132 25.5406 -0.783734 -33.5194 -209 2 11.2477 10.3841 3.29047 7.40472 -5.62792 30.1478 -210 2 12.3604 9.90108 4.31318 -36.068 9.82931 1.34024 -211 1 8.1924 12.225 3.79726 -5.69748 14.5101 56.1678 -212 2 9.05523 12.5573 4.13122 -12.2475 -6.42112 -18.1901 -213 2 7.61811 12.3317 4.63279 18.664 -10.6547 -44.172 -214 1 14.6446 4.04033 3.3856 3.29585 4.20735 14.8065 -215 2 15.1799 4.13354 4.21231 -10.8641 -1.34483 -21.0767 -216 2 13.7289 4.27483 3.60977 8.83721 -0.102893 1.13309 -217 1 5.73789 1.70847 7.633 -45.2268 -33.2589 19.0394 -218 2 5.00558 1.12579 8.07813 40.2552 34.7696 -21.6936 -219 2 5.52319 1.67762 6.69069 2.06189 0.609235 -2.30714 -220 1 17.8554 0.94247 4.83325 2.84508 1.94772 -6.32822 -221 2 18.4375 1.13729 4.06994 -6.68522 3.20321 14.3473 -222 2 17.8361 1.70281 5.4359 2.52705 -5.98387 -7.60558 -223 1 6.82607 9.13014 4.53731 -2.03949 -2.27606 -0.824268 -224 2 6.749 9.37751 5.45829 -4.27203 4.05265 7.19029 -225 2 7.76352 8.95198 4.44117 4.86868 -1.78157 -6.05796 -226 1 2.39805 14.6397 2.05874 17.0918 -1.49078 4.46086 -227 2 3.17145 14.6314 2.66377 -10.8679 0.525641 -12.6634 -228 2 2.72903 14.4183 1.17543 -1.81421 4.03234 5.90777 -229 1 17.1796 12.9575 13.0281 -10.0626 2.91445 0.0973403 -230 2 16.3048 13.3397 13.2675 20.7192 2.62525 -4.36947 -231 2 17.7682 13.6617 12.6978 -15.1419 2.46765 5.43564 -232 1 14.7925 10.5715 1.51204 -8.6843 -36.4521 -19.1925 -233 2 15.3686 11.2103 1.85793 27.186 33.4644 17.5702 -234 2 13.9217 10.9161 1.62765 -18.2001 7.18743 0.677482 -235 1 5.63756 6.65584 4.53835 -5.70194 -14.7917 8.95129 -236 2 5.96892 7.55557 4.50237 4.06113 5.5935 -1.33512 -237 2 6.19689 6.19506 5.18786 2.48768 6.43185 -8.34619 -238 1 8.1035 8.32015 10.3633 -6.06951 -1.51391 13.5103 -239 2 8.71051 8.88696 9.88772 3.75134 6.39998 -5.242 -240 2 7.4427 8.01108 9.7382 -0.891776 -1.59521 -4.95879 -241 1 13.4554 18.4382 5.64567 -23.0826 -2.6609 26.3697 -242 2 12.6541 0.350227 5.51512 12.1971 -9.37205 -2.29397 -243 2 13.2308 17.8847 6.43702 5.12544 9.06169 -21.995 -244 1 0.0481459 2.53289 0.450073 0.762545 20.3906 -8.36614 -245 2 17.7393 2.57826 18.829 23.3906 9.65711 1.86789 -246 2 0.50996 3.41343 0.303855 -21.6669 -27.8541 1.68488 -247 1 12.9745 10.8048 9.65469 -32.5048 41.5261 -13.285 -248 2 12.0083 11.0976 9.65119 33.8953 -25.1931 3.11551 -249 2 13.0333 9.87229 9.85209 -8.8072 -6.07099 4.09073 -250 1 0.527116 12.3319 11.2575 10.4347 -0.622496 2.4881 -251 2 18.2313 12.2915 11.4294 -10.2968 -1.46033 -6.74513 -252 2 0.909084 12.5363 12.117 7.12796 0.366826 -3.41572 -253 1 5.28415 7.34725 13.2845 -6.32664 2.65038 2.55184 -254 2 5.64713 8.17412 12.9655 4.82658 4.12789 -9.57053 -255 2 5.74627 7.2293 14.1116 0.316635 -7.58532 9.69513 -256 1 1.16454 6.74183 12.03 -13.1625 -42.3004 -9.02199 -257 2 0.295417 6.98712 11.7254 -9.09418 5.46945 -3.0829 -258 2 1.57891 7.53521 12.2772 19.8541 36.5775 12.6901 -259 1 15.5783 9.75012 12.4577 9.71681 16.8235 16.5595 -260 2 15.2431 10.6351 12.2158 0.950441 -15.6258 3.07953 -261 2 16.0853 9.89705 13.2804 -12.0519 -4.92211 -13.1427 -262 1 16.5993 12.6285 5.60521 -10.2494 37.6021 -45.7262 -263 2 16.4242 13.6113 5.62967 5.67224 -29.3823 14.3376 -264 2 16.441 12.4706 4.63081 7.92181 -5.25591 31.2114 -265 1 6.41284 9.90681 0.119653 0.515871 -10.7086 -9.9123 -266 2 5.64934 10.3727 0.465056 -3.06655 2.33505 3.46562 -267 2 7.14462 10.1266 0.702846 2.16363 1.41956 4.36049 -268 1 12.2095 5.93838 4.00309 -11.5544 -2.90268 -3.08172 -269 2 12.2942 6.66752 3.37735 2.08742 0.382808 1.33145 -270 2 11.2587 5.74648 4.01779 6.74513 0.670066 1.17813 -271 1 0.342924 12.9268 0.00967172 -2.71894 -2.13654 5.95194 -272 2 18.7348 13.4393 0.793746 3.88983 0.588143 -5.53597 -273 2 18.4589 13.2921 17.9296 1.41778 -5.28425 5.34754 -274 1 3.57599 18.7244 8.67011 -7.57313 7.8026 -17.3863 -275 2 3.53053 18.3214 7.79351 4.94999 -5.98969 2.51912 -276 2 2.6975 0.472694 8.72681 1.72246 -0.921876 11.7862 -277 1 7.19816 17.4543 4.42938 13.0422 27.6578 -13.842 -278 2 7.51541 18.3714 4.6455 -6.70989 -26.1973 -6.43912 -279 2 7.34255 17.3635 3.4592 -3.95356 0.0926602 20.0901 -280 1 9.24276 17.181 12.1874 27.1924 -9.91753 -12.8104 -281 2 9.16544 16.536 11.4403 4.06483 10.4089 22.9332 -282 2 10.1989 17.1789 12.4847 -33.3611 -0.423317 -5.22003 -283 1 13.2427 13.2324 7.99028 -4.63127 -11.2433 10.7708 -284 2 13.2975 12.5097 8.63573 0.309708 1.2863 -7.28868 -285 2 13.9184 13.8596 8.25103 7.01778 4.96536 -0.211076 -286 1 14.7706 2.86972 15.5058 12.3246 -20.976 -18.3849 -287 2 14.0341 2.28041 15.2496 10.8751 5.18171 6.07562 -288 2 15.4548 2.72916 14.8136 -15.3015 9.06101 10.4071 -289 1 9.96013 15.6554 16.9624 -0.416257 -4.3558 -3.6035 -290 2 10.3061 14.8055 16.6414 -1.75696 6.53817 2.71112 -291 2 9.61308 15.4752 17.8389 -3.07369 -3.40172 1.73448 -292 1 11.2206 8.54091 16.6271 11.2119 0.246209 -0.153837 -293 2 10.3853 8.13843 16.425 -12.7378 -7.75768 -8.20822 -294 2 11.7159 7.85532 17.0695 3.92811 -4.5145 7.83184 -295 1 4.19128 18.3534 16.7936 -2.0541 -15.6573 2.75359 -296 2 4.49896 17.6946 17.4386 1.3239 2.14246 -6.87061 -297 2 4.3476 0.553135 17.2025 -0.294224 9.43754 2.6314 -298 1 2.38271 4.321 8.90759 20.0465 -16.3105 29.2362 -299 2 3.33364 4.03277 8.87737 -27.5446 13.4253 -3.78204 -300 2 2.08958 4.1083 9.83354 7.71669 6.29647 -26.7475 -301 1 9.9842 10.4369 9.88352 -17.0195 21.6351 -0.0387615 -302 2 9.44133 11.1731 9.47934 17.4922 -21.0458 18.4718 -303 2 9.94225 10.4854 10.8652 2.27572 1.94662 -18.6097 -304 1 9.85899 0.920399 10.8075 0.162278 -2.63975 1.09763 -305 2 9.48302 0.0750215 11.0855 -2.58178 2.3482 3.77053 -306 2 9.21377 1.33985 10.2254 -0.0206645 -1.54215 -2.59695 -307 1 9.16055 15.229 10.2075 -19.4407 -6.65372 -14.862 -308 2 8.92137 15.8821 9.51239 -0.317996 -13.1788 14.0466 -309 2 8.43697 14.5477 10.1944 18.1534 21.6077 -0.815821 -310 1 0.71674 9.75329 10.1461 2.10813 23.2969 8.50765 -311 2 0.819344 10.7283 10.3167 -3.94998 -28.3852 -4.44668 -312 2 1.15296 9.53542 9.32246 0.728257 4.55427 -3.87479 -313 1 17.2456 4.88922 8.01698 -15.6269 -0.477795 25.7007 -314 2 16.4423 5.19943 8.52213 28.7194 -9.29348 -15.89 -315 2 17.7804 4.31587 8.60398 -15.5446 9.64156 -7.98894 -316 1 14.822 14.6129 0.044879 1.26259 -7.26488 27.1569 -317 2 15.5503 14.8635 0.654609 -16.5042 1.70925 -13.2775 -318 2 14.1019 14.3181 0.644441 11.2495 5.19015 -13.4399 -319 1 3.93398 11.151 9.56657 -13.0999 1.1143 6.92396 -320 2 3.8819 11.1389 10.5379 -0.108421 8.58768 -6.25849 -321 2 3.2885 11.8101 9.24754 8.95434 -7.44407 0.420275 -322 1 11.481 10.7372 1.49136 -12.2308 11.5287 -6.19882 -323 2 11.6479 11.6347 1.11375 -3.03535 -20.3842 8.82813 -324 2 10.5208 10.5745 1.38561 13.1816 3.92224 -1.496 -325 1 13.1382 7.21836 12.5396 -14.3564 7.08975 0.177427 -326 2 14.0771 7.12045 12.4061 13.875 -7.92794 3.07029 -327 2 12.7619 6.3345 12.5945 1.25366 -4.42296 3.81153 -328 1 9.68698 1.99848 0.824055 10.3256 0.727137 24.2023 -329 2 8.81917 1.78721 0.50968 -15.0497 -1.62599 -5.65 -330 2 10.155 2.38703 0.0980655 8.32187 5.69202 -13.7925 -331 1 10.602 13.3929 4.55586 17.4753 0.473987 25.0493 -332 2 11.4671 12.9458 4.66597 -13.9744 4.33191 -5.6004 -333 2 10.4831 13.8198 5.42698 -1.33045 -1.26907 -13.5894 -334 1 14.5505 1.55995 10.9504 0.793491 3.39408 -6.18689 -335 2 15.3506 1.17936 10.5364 -11.0229 12.1378 4.59402 -336 2 14.5582 2.53024 10.8225 7.4254 -12.0179 1.55597 -337 1 14.4508 12.0407 11.6074 10.4267 -5.99888 -36.1251 -338 2 15.2905 12.2256 11.0848 -31.5625 -1.98982 15.431 -339 2 13.8033 11.6041 10.9773 26.0423 16.8772 21.3357 -340 1 8.16091 5.15464 9.81808 -31.1733 -3.04727 19.1057 -341 2 7.28259 5.21015 10.2725 23.9466 4.77499 -10.0641 -342 2 8.23945 4.21356 9.63446 4.25293 -1.90524 -4.29988 -343 1 1.57078 16.9857 18.5145 2.11582 4.65495 -1.34384 -344 2 1.81738 17.3492 17.6562 0.32294 -2.46744 1.69741 -345 2 1.87051 16.0745 18.5076 0.982883 -4.60963 -1.80737 -346 1 1.40224 17.4231 15.3612 30.835 -28.8708 -16.9337 -347 2 1.58171 18.2262 15.8024 1.01568 35.607 16.5514 -348 2 0.474852 17.284 15.3634 -28.8421 -6.17683 0.802216 -349 1 3.44554 5.70547 6.04619 4.62282 22.475 -0.524537 -350 2 3.1428 6.44974 6.61309 0.90031 -17.6364 -10.4242 -351 2 4.06586 6.09018 5.39907 -5.11167 -0.757253 7.03456 -352 1 12.635 9.5385 14.2471 10.4135 -57.691 -2.75625 -353 2 13.0561 8.75521 13.7543 -17.7171 41.3381 15.7803 -354 2 12.3533 9.10151 15.082 0.88858 17.3566 -13.7461 -355 1 4.11217 15.1814 7.19429 24.0597 14.9458 -6.20919 -356 2 3.65166 15.9525 6.80506 8.00815 -8.18076 7.53786 -357 2 5.09537 15.3539 7.08579 -34.9804 -3.92885 1.78443 -358 1 0.830872 8.84313 15.1657 1.50937 4.0339 -6.81168 -359 2 0.547306 9.77972 15.0966 9.11455 -14.6477 -1.64448 -360 2 1.6109 8.72602 14.589 -11.0561 6.95599 3.23137 -361 1 12.8981 8.26079 10.0923 10.5692 -21.7103 -4.02448 -362 2 13.6229 7.70102 9.77244 -0.136865 10.7899 -7.02632 -363 2 12.7945 7.93077 10.9815 -6.52785 3.68747 11.7154 -364 1 15.1981 8.09018 3.38532 -13.0459 -52.6521 2.11346 -365 2 14.5247 7.61376 2.86907 3.36606 26.685 -8.7616 -366 2 15.3386 7.39586 4.05885 15.5852 26.7124 4.01456 -367 1 17.1365 6.7605 0.0284285 -19.4133 2.32297 -2.08842 -368 2 16.6422 5.96523 0.300426 11.1165 9.80228 -2.81184 -369 2 16.4267 7.37993 18.3943 16.5678 -7.00446 5.84521 -370 1 8.97527 7.00353 7.90402 -12.8517 -1.3564 7.9131 -371 2 9.8962 7.25242 7.83012 8.98921 2.98997 4.36252 -372 2 8.82463 6.62979 8.79874 5.5237 0.780274 -18.1173 -373 1 12.5342 0.599732 1.22272 7.37234 -11.2249 5.10795 -374 2 13.3221 0.863275 1.71742 -3.27048 6.46822 -3.34517 -375 2 12.885 0.18837 0.429335 -4.8121 3.35952 -2.50919 -376 1 5.70486 15.0289 14.4325 -10.0966 26.0987 -8.04315 -377 2 4.75654 15.1126 14.6498 8.83064 -2.51751 -1.0487 -378 2 5.99172 15.9344 14.1552 -2.67099 -19.6319 8.34541 -379 1 3.68772 6.51886 1.67786 -9.02664 17.532 -4.1283 -380 2 3.3123 7.35563 1.32777 6.95322 -18.4916 -0.718273 -381 2 3.69933 6.70385 2.62114 4.49099 -5.2411 1.79351 -382 1 3.84119 11.2683 12.301 -11.0219 1.87445 3.30422 -383 2 4.7083 11.6207 12.5295 0.62865 1.71432 1.43021 -384 2 3.16952 11.829 12.7259 9.18863 0.324364 -2.3982 -385 1 5.33774 3.90131 15.6575 3.88008 58.1131 -0.302695 -386 2 6.0029 3.30263 15.356 18.6017 -19.7261 -0.90724 -387 2 5.77609 4.81808 15.6348 -20.8077 -39.2998 1.51453 -388 1 13.9476 10.0954 4.76119 43.1598 -13.631 -14.8551 -389 2 14.3099 9.89525 5.64952 -11.5358 -2.78357 -16.2598 -390 2 14.5437 9.62633 4.09138 -26.3956 16.5702 30.5617 -391 1 7.47949 17.2779 8.9575 1.27559 12.2273 10.3752 -392 2 6.80648 17.541 9.63427 13.3482 -0.885269 -20.4433 -393 2 7.81637 18.0666 8.4826 -8.0179 -7.75644 7.92076 -394 1 4.60365 14.3557 3.73459 -2.67085 -0.0597314 40.4087 -395 2 4.53549 15.2621 4.14744 4.43815 -28.6634 -11.7113 -396 2 4.62044 13.6529 4.46513 -1.80956 31.3212 -27.6241 -397 1 14.2431 7.29194 15.9057 25.6353 16.9765 2.1683 -398 2 15.0475 7.32515 15.3368 -17.0197 -3.00413 14.2387 -399 2 14.4656 7.87429 16.6673 -6.53416 -15.6271 -13.0076 -400 1 2.96496 18.4208 1.99119 15.7852 32.1682 20.7835 -401 2 2.67672 17.8955 1.28044 -15.5564 -27.5435 -28.9446 -402 2 2.23493 0.385121 2.17733 5.2916 -3.96739 2.45348 -403 1 7.98476 1.5873 4.50407 1.38949 2.52923 0.695279 -404 2 7.37343 2.0449 3.91068 5.19751 -1.80104 2.00097 -405 2 8.86519 1.9238 4.29038 -5.22298 -3.29695 -0.501883 -406 1 2.57117 14.1691 17.7571 1.007 -17.2424 4.53378 -407 2 1.90219 13.4698 17.9606 14.5878 19.4169 -2.4542 -408 2 3.44824 13.7555 17.8862 -10.6426 1.83574 2.42644 -409 1 1.00451 2.03285 13.8784 10.3502 2.39599 -10.3714 -410 2 1.16144 1.84563 14.7992 2.97823 -2.88805 14.0985 -411 2 0.0700994 1.90667 13.7535 -13.5508 1.82952 -2.05389 -412 1 4.33902 0.200757 13.8843 13.0721 -10.005 -1.30306 -413 2 5.22858 18.4296 13.858 -15.0619 9.43809 1.75921 -414 2 3.93054 18.5168 14.6942 4.28146 4.19272 1.73225 -415 1 7.39543 1.05973 18.4904 -6.66444 -3.84456 4.72925 -416 2 7.66739 0.634389 17.6825 2.48525 -3.87431 -15.5197 -417 2 6.44311 1.20989 18.4324 3.08246 -0.882049 5.31666 -418 1 15.7652 18.4035 13.928 -3.86344 6.1861 11.5309 -419 2 14.8535 18.6979 13.7607 9.26883 -6.83338 6.65234 -420 2 15.8985 -0.310566 14.8997 -7.7909 7.80446 -17.2978 -421 1 10.2952 4.64795 16.1844 -42.7729 -17.7833 -2.18791 -422 2 11.2045 4.84382 16.2798 37.5776 1.06228 1.58962 -423 2 10.2217 3.67206 16.1998 1.46017 15.0252 -2.22652 -424 1 15.8927 17.6472 4.46477 -15.4234 23.5431 17.5975 -425 2 16.4754 18.4255 4.65687 -16.3789 -18.5079 -6.3799 -426 2 14.9773 17.9018 4.78742 33.6258 -6.52099 -13.8394 -427 1 6.90155 17.6195 13.966 46.0362 -18.082 7.69792 -428 2 7.5054 17.5909 14.7751 -24.8486 6.04139 -28.3759 -429 2 7.50943 17.3755 13.214 -16.8133 11.713 21.5591 -430 1 13.2082 6.37265 6.52765 -13.548 -6.29238 7.5029 -431 2 14.0171 6.83631 6.34759 17.8515 4.0742 0.884882 -432 2 12.7912 6.26458 5.66961 -1.80962 -1.49443 -3.94736 -433 1 7.85263 2.26509 9.52735 -7.99894 -5.84405 -22.7054 -434 2 7.25184 2.06178 10.2504 -3.996 2.15095 3.09306 -435 2 7.39499 1.97805 8.69805 10.2818 7.88442 20.3126 -436 1 15.1135 14.8377 13.7906 -14.0873 7.85215 4.54273 -437 2 14.8065 15.1503 14.6696 4.89633 -5.66092 -15.9193 -438 2 14.526 15.2486 13.1323 8.68819 -2.70507 8.56313 -439 1 9.34389 8.42481 3.82801 17.2784 -12.6228 -3.36469 -440 2 10.2481 8.71643 4.0808 -19.781 -0.493733 -4.13474 -441 2 9.39514 7.45876 3.71283 -1.01674 10.6173 4.41109 -442 1 17.6406 13.5721 16.5094 2.04355 14.6677 -13.2606 -443 2 16.6957 13.3564 16.5004 3.03121 5.86868 -4.35941 -444 2 17.7908 14.3862 15.9732 -9.46726 -16.3028 8.56732 -445 1 4.98477 10.3524 2.78056 12.7386 5.36526 19.5004 -446 2 5.77841 9.87677 3.08402 -8.11584 2.70387 -5.95057 -447 2 4.78102 10.9105 3.55814 -3.18863 -4.34789 -14.1468 -448 1 3.61985 8.409 9.90418 -6.90754 6.83907 7.996 -449 2 3.65115 9.35813 9.71914 3.08439 -3.40065 -3.71786 -450 2 3.2182 8.36489 10.7858 3.70965 -2.47637 -5.74153 -451 1 15.9601 6.9243 5.80742 5.84252 7.06727 3.15212 -452 2 16.6786 7.33659 6.3256 -10.6597 -9.43019 -8.8571 -453 2 16.2068 5.99858 5.66915 1.21675 5.97088 2.68601 -454 1 15.2845 7.30815 8.96614 12.789 49.367 -12.5087 -455 2 15.9618 7.62249 9.60336 -10.429 -10.3168 -7.48119 -456 2 15.189 8.09577 8.33246 -3.07462 -40.144 23.8491 -457 1 6.1828 12.7537 12.7561 7.28509 13.2747 4.63662 -458 2 7.05451 12.4627 13.0861 -13.4204 -0.208789 -0.140696 -459 2 5.95622 13.5898 13.2147 8.13015 -13.1574 -2.88232 -460 1 12.1263 4.55994 13.1396 29.7192 24.8274 2.05513 -461 2 12.1786 4.68706 14.0984 -0.0287765 -3.56256 -2.83377 -462 2 11.367 4.05454 12.9285 -29.3831 -17.3036 -0.987503 -463 1 11.4694 8.07241 7.80966 2.82892 -5.30182 3.11258 -464 2 12.1089 7.42736 7.43222 -7.16455 14.3649 9.80055 -465 2 11.7078 8.26067 8.74179 3.19872 -8.99269 -16.594 -466 1 16.9463 10.7531 7.60486 21.0922 -19.3927 -30.7185 -467 2 17.5464 10.0071 7.31859 -16.0594 21.8542 15.0855 -468 2 16.9098 11.3402 6.82058 -3.06841 -4.58473 14.7168 -469 1 5.28146 18.0409 10.6472 -25.9515 -7.83546 -6.26387 -470 2 4.85268 17.2439 11.0337 11.609 18.382 -10.1496 -471 2 4.62194 18.3715 9.98111 20.3861 -11.8767 18.8687 -472 1 7.65293 17.466 1.56177 -3.43219 -2.17163 16.4468 -473 2 8.27069 16.8213 1.23778 3.23069 -17.6415 -5.16563 -474 2 7.58305 18.0963 0.859771 -3.72786 20.9018 -9.77855 -475 1 1.92587 12.9087 13.6164 -8.16731 5.11551 18.4441 -476 2 1.30634 12.3949 14.1755 13.4846 7.44573 -7.00244 -477 2 2.13079 13.7319 14.1159 -1.95883 -16.9131 -9.84331 -478 1 9.29336 6.75339 14.7687 -19.1125 21.7104 1.76678 -479 2 9.711 5.9819 15.1082 15.9481 -24.452 8.13362 -480 2 9.58853 6.88119 13.8676 2.75751 0.822828 -8.36077 -481 1 15.2452 4.28737 10.7623 -0.225576 -4.08648 -1.74219 -482 2 16.1503 3.99339 10.8719 6.1947 -5.72264 -8.71474 -483 2 15.1717 4.92602 11.4736 -7.0877 3.5816 0.665059 -484 1 11.4391 6.24473 0.0517087 -15.4849 -28.4826 -7.88372 -485 2 11.5335 5.29025 18.4586 5.11122 21.8085 5.83846 -486 2 10.469 6.36117 18.7264 13.3105 4.99187 -1.92993 -487 1 18.4571 11.4845 14.9094 -8.14212 27.2991 -26.8701 -488 2 18.0442 12.0056 14.1458 10.7134 -26.1217 30.6713 -489 2 18.3691 12.0954 15.6567 -1.55188 -2.54901 -1.51407 -490 1 7.07006 9.2713 7.35429 3.52198 -23.4346 -4.90088 -491 2 6.57918 8.46088 7.59869 6.01934 15.522 -0.341791 -492 2 7.98054 8.95273 7.2441 -4.91945 6.78887 2.19469 -493 1 18.4213 15.3485 12.1512 14.6289 14.7183 -5.00343 -494 2 0.703338 15.6554 12.0361 -12.928 -5.55139 4.18882 -495 2 17.8805 15.9633 11.6295 -1.60931 -6.92771 2.64168 -496 1 16.5853 4.3259 5.32941 -3.23822 -14.2219 46.7572 -497 2 16.614 4.15863 6.32722 1.43031 7.89007 -40.0485 -498 2 17.5031 4.43236 5.0545 -4.12857 4.88068 -4.00684 -499 1 17.7656 3.15988 10.7489 -7.77815 -3.54726 5.22618 -500 2 18.6517 3.33727 11.1036 -6.02481 -6.41431 -8.69585 -501 2 17.7347 2.25304 10.4054 5.10772 5.83768 0.491016 -502 1 12.3532 18.6195 10.0845 2.26138 29.9542 0.82462 -503 2 11.4554 0.369133 10.2956 34.814 -7.7062 -6.49387 -504 2 13.0539 0.703372 10.1287 -31.4455 -25.8056 2.12568 -505 1 10.4062 9.7592 12.5463 4.94309 9.48659 9.1975 -506 2 11.1178 9.86775 13.2051 -4.84217 -3.21907 -8.75193 -507 2 10.4169 8.83 12.3092 -0.242296 -5.43122 1.67162 -508 1 0.754807 2.57366 7.2759 5.10959 9.37805 -1.17349 -509 2 1.15147 3.40426 7.59563 -2.53061 -11.14 3.70439 -510 2 0.94825 1.90755 7.95351 -0.370046 8.4477 -4.76995 -511 1 0.326852 15.3245 6.92393 7.78779 -47.7914 -15.9381 -512 2 0.478367 15.1955 7.87742 -3.54148 6.5065 -12.4551 -513 2 0.511792 14.4078 6.50445 -6.22026 47.2618 21.2659 -514 1 17.0448 6.87527 14.9011 7.50868 -3.64469 2.18783 -515 2 17.7829 7.50382 14.839 -4.82102 -5.02166 1.59119 -516 2 17.384 6.09018 15.3732 -3.19441 8.7454 -5.86774 -517 1 9.10521 12.4991 8.01627 -22.444 -7.37457 -9.07321 -518 2 9.5155 11.7197 7.59468 -6.97176 5.64777 -5.01838 -519 2 8.17012 12.5725 7.67989 31.3303 -7.17656 9.91942 -520 1 1.12679 1.65794 2.79756 -4.95635 8.46302 6.6874 -521 2 0.642552 2.15227 2.11219 8.6081 -1.07022 6.53976 -522 2 1.60228 2.28223 3.37541 -5.16033 -3.32404 -9.46208 -523 1 4.24509 15.0269 10.0531 -9.28044 4.63084 -2.70058 -524 2 3.93721 15.2031 9.15401 2.26907 2.00751 2.33164 -525 2 5.07496 14.5648 9.92961 6.13338 0.348707 3.17177 -526 1 7.39613 2.22212 14.8791 -10.1428 -2.73186 -2.62368 -527 2 7.12857 1.59843 14.1951 -0.211704 -1.85534 3.14611 -528 2 7.6308 3.01777 14.3992 6.19568 3.75469 -5.36272 -529 1 18.3005 14.5161 2.14907 5.30067 -9.26209 1.4902 -530 2 0.506128 14.8057 2.49377 4.6744 -0.083839 -4.04908 -531 2 17.8019 15.308 1.97101 -9.85855 11.1774 -0.48774 -532 1 10.0782 2.71092 12.8944 3.88974 -3.73664 -2.78909 -533 2 9.88925 2.05355 12.2072 4.3936 3.86452 2.74403 -534 2 9.31937 3.3006 12.9074 -3.94823 0.261307 -1.05017 -535 1 2.9306 8.79131 12.9512 -25.6961 -20.8645 -0.44372 -536 2 3.33593 9.62792 12.788 10.417 21.0465 -4.83397 -537 2 3.64632 8.1716 13.058 11.1871 -7.80414 6.67576 -538 1 3.17851 8.59155 3.78391 36.0219 9.48042 20.5594 -539 2 3.64638 9.17092 3.16182 -4.0064 -4.18597 2.27442 -540 2 3.67104 8.74964 4.63715 -24.9674 -6.25544 -24.3579 -541 1 5.79667 7.27872 8.61723 -5.158 -8.45889 2.36629 -542 2 5.76122 6.32524 8.453 -1.10357 3.40671 2.32671 -543 2 5.00318 7.4879 9.12925 4.38374 0.567505 0.838777 -544 1 14.9116 1.65307 1.84567 7.03031 -5.18946 -10.6018 -545 2 15.1062 2.45757 2.3139 -4.94852 6.93451 15.0643 -546 2 15.1691 1.84916 0.935056 -0.310542 -6.30296 3.0909 -547 1 8.67523 15.0369 0.613894 1.37845 1.1536 3.61737 -548 2 9.43682 15.0729 1.21213 -3.42809 -6.51916 3.89646 -549 2 8.00447 14.4711 1.03609 4.49017 7.63347 -1.72767 -550 1 15.3993 1.47022 7.19229 -20.8703 -2.58026 0.276614 -551 2 14.6837 0.967989 6.72584 19.4319 15.0033 11.4079 -552 2 14.9834 2.26826 7.5843 2.60239 -12.333 -11.18 -553 1 4.89704 12.855 18.4725 17.7474 3.66438 12.0852 -554 2 5.22521 13.0209 0.739851 -5.30909 -3.44768 -15.7686 -555 2 5.64886 13.1114 17.9131 -8.88833 1.88365 4.35483 -556 1 15.3966 8.71526 18.0579 -0.0737912 10.217 -6.92241 -557 2 15.7913 9.20885 17.3059 -4.72516 -6.1114 19.2356 -558 2 15.2466 9.35419 0.13361 -0.210218 -4.05252 -7.18588 -559 1 11.9654 3.16879 18.3684 -1.96391 -6.33771 9.57431 -560 2 11.8782 2.93896 0.667559 5.83177 -2.01678 -11.7343 -561 2 12.3624 2.38725 17.9444 -0.743858 8.0566 3.61175 -562 1 13.1976 12.733 5.19814 3.21154 2.81721 -3.88454 -563 2 13.6265 11.8743 5.11099 -2.80289 -1.59076 -2.45209 -564 2 13.3962 13.0406 6.08845 -1.48061 -3.43823 1.63358 -565 1 6.20234 7.07161 0.291392 8.37087 -8.50913 -15.2358 -566 2 6.21431 8.03007 18.9132 -3.08565 9.14852 3.50692 -567 2 5.28911 6.79756 0.384068 -8.05152 4.04277 7.5169 -568 1 17.755 15.8811 14.8809 -0.846783 4.67036 -1.95176 -569 2 16.8205 16.1356 14.922 6.46156 -5.25763 -8.70949 -570 2 17.9775 15.7319 13.9423 -7.01069 1.37948 9.8425 -571 1 13.0816 0.927432 16.7559 7.19813 -13.1533 1.9849 -572 2 14.0246 0.654652 16.7787 -14.5584 8.9122 1.46691 -573 2 12.5958 0.0867106 16.6751 4.09548 8.26383 -2.86333 -574 1 10.8721 14.5032 7.42074 17.8947 27.9436 -17.0444 -575 2 10.196 13.9242 7.71676 -22.829 -18.2345 11.9548 -576 2 11.6972 14.0514 7.58445 7.42519 -9.80791 -0.577526 -577 1 17.7647 8.42346 2.16939 -4.1598 1.60766 -5.89387 -578 2 16.8709 8.3975 2.49669 -12.234 5.23478 11.868 -579 2 17.7295 7.75318 1.48744 5.54579 -3.65645 -10.0136 -580 1 12.5773 7.79072 2.0332 1.0668 2.49746 -6.2566 -581 2 12.3914 8.73063 1.87761 -0.101344 -7.79782 -0.82295 -582 2 12.2276 7.2965 1.27263 1.31444 5.98607 5.5368 -583 1 12.0208 14.4615 10.4933 -27.7219 6.00234 -17.9899 -584 2 12.3406 14.2687 9.58404 -10.0812 4.98999 20.4987 -585 2 11.0483 14.7039 10.4238 33.6221 -8.97773 -1.58279 -586 1 6.69486 6.68845 15.5484 18.1135 9.98152 11.3143 -587 2 7.65688 6.85274 15.3559 -27.8703 -4.06425 5.81014 -588 2 6.48582 7.17335 16.3722 6.10572 -10.2019 -13.6564 -589 1 7.96659 4.39718 13.2272 4.51058 -7.9075 4.77481 -590 2 7.2893 4.70584 12.6248 -6.54048 3.46732 -4.14994 -591 2 8.21018 5.15068 13.7582 2.30488 10.1178 3.17748 -592 1 13.2671 12.2369 14.4347 -4.64765 -4.51239 1.04229 -593 2 13.0608 11.2949 14.304 4.07546 7.63325 0.952283 -594 2 13.624 12.5445 13.5893 -0.484314 -1.81518 4.66288 -595 1 14.4631 9.64208 7.37348 -3.22195 -17.9745 -8.46037 -596 2 15.2455 10.1455 7.54143 19.6931 12.3162 5.07411 -597 2 13.7594 10.075 7.84063 -11.2512 5.66435 9.63044 -598 1 12.6955 16.8004 3.38503 4.61351 40.5798 -15.2407 -599 2 12.79 17.4151 4.16128 -2.51333 -18.5745 -25.4999 -600 2 12.6728 17.373 2.55111 0.0132769 -17.6878 38.2975 -601 1 0.968812 6.96727 17.3326 -17.527 29.8281 -14.7856 -602 2 0.0966102 7.11435 17.7475 9.38145 -12.9539 -1.45746 -603 2 0.942675 7.56475 16.5473 6.51552 -11.7527 16.88 -604 1 12.9918 4.86088 15.7598 14.9884 1.53364 0.213735 -605 2 13.6417 4.12341 15.6561 -13.2544 27.5281 4.62454 -606 2 13.5036 5.69571 15.8607 -8.5455 -17.4296 -3.38108 -607 1 2.31456 3.41181 5.02375 -16.8072 14.5355 28.5245 -608 2 1.72499 3.01856 5.74541 26.0591 16.5367 -23.5498 -609 2 2.61813 4.33638 5.31016 -13.7452 -42.3935 -5.38282 -610 1 8.12877 10.8743 13.7813 26.8177 -26.1009 35.9685 -611 2 8.08888 10.4248 14.7095 5.12746 27.8083 -58.2879 -612 2 8.93477 10.511 13.3312 -19.2021 7.65314 13.0743 -613 1 13.0038 1.57226 13.2324 0.46489 2.31008 -10.6366 -614 2 13.6096 1.43937 12.4592 -18.9356 10.6634 16.2552 -615 2 12.412 2.34128 13.062 19.3329 -16.3736 -0.813643 -616 1 6.65189 13.7072 1.97939 -2.77776 -1.20266 13.9341 -617 2 6.01392 14.2112 2.53362 13.0928 -13.1372 -7.18637 -618 2 7.15166 13.1216 2.589 -8.8324 11.1791 -7.86511 -619 1 15.7768 6.33135 12.4394 -16.9523 -8.61752 -2.39927 -620 2 16.2545 6.83373 11.7966 11.5481 11.8457 -13.8092 -621 2 16.2346 6.49819 13.2509 8.584 1.06891 20.063 -622 1 16.7487 0.656157 9.53186 -1.89022 -32.3669 -10.6998 -623 2 16.6929 18.3191 9.69193 -1.14735 24.5709 0.588436 -624 2 16.3744 0.798362 8.64008 0.39513 1.76057 8.35052 -625 1 6.2256 11.6996 8.23382 -7.45249 -33.5883 4.29961 -626 2 5.41287 11.5766 8.79278 22.02 -5.73867 -21.2662 -627 2 6.53136 10.7979 7.88958 -15.1732 37.063 20.6987 -628 1 2.75779 8.608 0.340468 -48.3199 -4.33351 -7.97969 -629 2 2.08546 8.0585 18.4464 30.1073 27.602 24.3697 -630 2 2.23564 9.25518 0.892435 12.8354 -18.7139 -20.5564 -631 1 10.0773 10.2182 6.62419 2.67327 1.92209 4.62159 -632 2 10.5668 9.53044 7.10449 -1.07652 4.95909 -5.68289 -633 2 10.5655 10.3766 5.79827 -6.62323 -4.53969 7.46345 -634 1 6.84859 15.7294 6.8116 4.5172 -4.61086 -5.81045 -635 2 7.14728 16.2498 7.57791 -4.63192 -2.64256 -11.095 -636 2 7.17659 16.1616 6.00258 -4.95191 3.23702 9.76552 -637 1 6.62071 12.9207 5.93401 2.33655 2.8557 1.84805 -638 2 6.83452 13.8255 6.17261 -0.629609 6.79635 0.913528 -639 2 6.25462 12.5309 6.73716 -1.14115 0.401949 -5.14594 -640 1 16.7089 12.5339 9.77339 -0.869689 -1.39856 -8.71911 -641 2 16.7622 11.7819 9.15626 3.31473 10.0385 4.47785 -642 2 17.1611 13.2788 9.34464 -3.7572 -10.2702 6.17681 -643 1 6.29845 2.79213 2.75928 -3.20566 -14.4941 8.67087 -644 2 6.41489 3.68807 2.47435 5.42045 18.7619 -3.24562 -645 2 5.94058 2.32523 2.00482 -4.41542 -3.11109 -6.82659 -646 1 10.6289 2.95834 3.25769 -6.57134 8.8614 -3.08687 -647 2 10.3824 3.87829 3.42309 -0.834706 -5.50201 2.33367 -648 2 10.1446 2.71475 2.45701 2.51779 -3.35726 0.152255 diff --git a/examples/amoeba/dump.water_dimer.amoeba.1.test b/examples/amoeba/dump.water_dimer.amoeba.1.test deleted file mode 100644 index ec6d3eb2cd..0000000000 --- a/examples/amoeba/dump.water_dimer.amoeba.1.test +++ /dev/null @@ -1,165 +0,0 @@ -ITEM: TIMESTEP -0 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.024616 -0.001154 -0.003748 7.94661 0.0143882 11.5654 -2 2 -0.244211 -0.000666 0.933978 -7.05777 -0.00770443 -3.06431 -3 2 0.932234 -0.000406 -0.008705 -0.956334 -0.00629552 -7.87238 -4 1 -0.892721 0.00012 2.77367 -12.7377 -0.00815373 2.78728 -5 2 -1.463 0.75512 2.93387 6.39935 4.06267 -1.71086 -6 2 -1.46181 -0.755549 2.93493 6.40581 -4.05491 -1.70517 -ITEM: TIMESTEP -10 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0210901 -0.00114727 0.00187855 -6.1441 -0.00926688 -6.30688 -2 2 -0.299755 -0.000716119 0.924842 7.69349 0.00623407 0.274054 -3 2 0.933941 -0.000453269 -0.0777281 -1.08824 0.00357639 6.29137 -4 1 -0.89902 0.000115499 2.77431 8.40057 0.0041921 -3.3195 -5 2 -1.41411 0.797948 2.92323 -4.42685 -5.12343 1.53409 -6 2 -1.41285 -0.798315 2.92435 -4.43485 5.1187 1.52687 -ITEM: TIMESTEP -20 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0253162 -0.0011519 9.30621e-06 6.65721 0.0114207 8.7962 -2 2 -0.214112 -0.000636438 0.94263 -7.71284 -0.00678668 -1.03908 -3 2 0.928921 -0.000430955 -0.0404651 0.717191 -0.00462784 -7.37266 -4 1 -0.894334 0.00011596 2.76974 -10.0965 -0.00568803 3.16137 -5 2 -1.45804 0.75449 2.94684 5.21348 5.11475 -1.77652 -6 2 -1.45685 -0.754893 2.9479 5.22149 -5.10907 -1.76931 -ITEM: TIMESTEP -30 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0221554 -0.0011439 0.00783939 -8.36895 -0.0130834 -9.24354 -2 2 -0.25261 -0.000667783 0.941075 6.36112 0.00692164 2.73081 -3 2 0.92432 -0.000494304 -0.125343 2.07038 0.00615069 6.42537 -4 1 -0.900866 0.00010992 2.76846 11.0986 0.00640696 -3.42785 -5 2 -1.40977 0.795072 2.93807 -5.57817 -3.04583 1.75974 -6 2 -1.40852 -0.795411 2.93919 -5.58301 3.03943 1.75548 -ITEM: TIMESTEP -40 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0269208 -0.00114842 0.00674288 5.42877 0.00730481 4.31748 -2 2 -0.171607 -0.000594964 0.954009 -8.40692 -0.00484075 2.50346 -3 2 0.92209 -0.000466908 -0.0840066 2.3456 -0.00296432 -6.82561 -4 1 -0.895716 0.000110956 2.76419 -6.18264 -0.00259137 3.07323 -5 2 -1.45218 0.754436 2.95353 3.40261 6.39649 -1.53879 -6 2 -1.45099 -0.75482 2.9546 3.41259 -6.3934 -1.52976 -ITEM: TIMESTEP -50 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0239329 -0.00114175 0.0128926 -8.15007 -0.014184 -11.0504 -2 2 -0.230937 -0.000644481 0.949766 5.72493 0.00756591 4.36142 -3 2 0.91871 -0.000511822 -0.144074 2.40885 0.00639366 6.3907 -4 1 -0.899724 0.000108594 2.76531 11.5106 0.00694105 -3.03119 -5 2 -1.41275 0.792848 2.92798 -5.74551 -2.08247 1.6662 -6 2 -1.41151 -0.793206 2.9291 -5.7488 2.07576 1.66327 -ITEM: TIMESTEP -60 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0287434 -0.0011479 0.00953424 6.82379 0.00862743 4.63675 -2 2 -0.180318 -0.000600308 0.956082 -8.03241 -0.00482631 2.10983 -3 2 0.922397 -0.000459471 -0.0739414 0.782565 -0.00412295 -6.72684 -4 1 -0.892694 0.000113827 2.76489 -6.55004 -0.00361317 2.26756 -5 2 -1.45749 0.757284 2.91975 3.48398 5.14308 -1.14726 -6 2 -1.4563 -0.757724 2.92081 3.49211 -5.13915 -1.14003 -ITEM: TIMESTEP -70 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.025848 -0.00114271 0.0136758 -6.10179 -0.0106002 -8.24377 -2 2 -0.259382 -0.000669072 0.94681 6.59121 0.0065405 1.93161 -3 2 0.923692 -0.000484045 -0.110366 -0.0484081 0.00428029 6.1322 -4 1 -0.894893 0.000114175 2.76783 7.43985 0.00424265 -2.1131 -5 2 -1.42416 0.79251 2.88639 -3.9377 -3.53776 1.14903 -6 2 -1.42292 -0.792944 2.88751 -3.94318 3.53329 1.14403 -ITEM: TIMESTEP -80 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.030135 -0.00114891 0.00965506 7.41429 0.0123912 9.3266 -2 2 -0.213346 -0.000627628 0.954378 -6.76672 -0.00675668 -2.04974 -3 2 0.924938 -0.000432456 -0.0385785 -0.591495 -0.00546702 -7.10385 -4 1 -0.888796 0.000119275 2.76827 -9.03539 -0.00642914 1.05959 -5 2 -1.46214 0.762697 2.87512 4.48797 2.10983 -0.617778 -6 2 -1.46094 -0.763208 2.87619 4.49133 -2.10357 -0.61482 -ITEM: TIMESTEP -90 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0270206 -0.00114299 0.0145983 -6.11813 -0.00811207 -4.69194 -2 2 -0.274281 -0.000680382 0.947366 7.50569 0.00503125 -1.23144 -3 2 0.92514 -0.000469353 -0.0912836 -0.650877 0.00352314 5.72916 -4 1 -0.891964 0.000116952 2.76852 3.17186 0.0014363 -1.52231 -5 2 -1.43137 0.791127 2.86377 -1.95059 -4.67792 0.861555 -6 2 -1.43013 -0.791605 2.86488 -1.95795 4.67604 0.85497 -ITEM: TIMESTEP -100 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.030669 -0.00114759 0.0121427 6.42493 0.0120997 10.0073 -2 2 -0.203569 -0.000615753 0.960107 -6.40597 -0.00736639 -3.30674 -3 2 0.923036 -0.000442107 -0.0503324 -0.0528607 -0.00477186 -6.71539 -4 1 -0.889443 0.000116814 2.76553 -7.7691 -0.0050422 1.37075 -5 2 -1.45671 0.76736 2.88018 3.9012 0.426437 -0.678284 -6 2 -1.4555 -0.767854 2.88126 3.9018 -0.421357 -0.677675 diff --git a/examples/amoeba/dump.water_dimer.amoeba.4.test b/examples/amoeba/dump.water_dimer.amoeba.4.test deleted file mode 100644 index ec6d3eb2cd..0000000000 --- a/examples/amoeba/dump.water_dimer.amoeba.4.test +++ /dev/null @@ -1,165 +0,0 @@ -ITEM: TIMESTEP -0 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.024616 -0.001154 -0.003748 7.94661 0.0143882 11.5654 -2 2 -0.244211 -0.000666 0.933978 -7.05777 -0.00770443 -3.06431 -3 2 0.932234 -0.000406 -0.008705 -0.956334 -0.00629552 -7.87238 -4 1 -0.892721 0.00012 2.77367 -12.7377 -0.00815373 2.78728 -5 2 -1.463 0.75512 2.93387 6.39935 4.06267 -1.71086 -6 2 -1.46181 -0.755549 2.93493 6.40581 -4.05491 -1.70517 -ITEM: TIMESTEP -10 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0210901 -0.00114727 0.00187855 -6.1441 -0.00926688 -6.30688 -2 2 -0.299755 -0.000716119 0.924842 7.69349 0.00623407 0.274054 -3 2 0.933941 -0.000453269 -0.0777281 -1.08824 0.00357639 6.29137 -4 1 -0.89902 0.000115499 2.77431 8.40057 0.0041921 -3.3195 -5 2 -1.41411 0.797948 2.92323 -4.42685 -5.12343 1.53409 -6 2 -1.41285 -0.798315 2.92435 -4.43485 5.1187 1.52687 -ITEM: TIMESTEP -20 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0253162 -0.0011519 9.30621e-06 6.65721 0.0114207 8.7962 -2 2 -0.214112 -0.000636438 0.94263 -7.71284 -0.00678668 -1.03908 -3 2 0.928921 -0.000430955 -0.0404651 0.717191 -0.00462784 -7.37266 -4 1 -0.894334 0.00011596 2.76974 -10.0965 -0.00568803 3.16137 -5 2 -1.45804 0.75449 2.94684 5.21348 5.11475 -1.77652 -6 2 -1.45685 -0.754893 2.9479 5.22149 -5.10907 -1.76931 -ITEM: TIMESTEP -30 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0221554 -0.0011439 0.00783939 -8.36895 -0.0130834 -9.24354 -2 2 -0.25261 -0.000667783 0.941075 6.36112 0.00692164 2.73081 -3 2 0.92432 -0.000494304 -0.125343 2.07038 0.00615069 6.42537 -4 1 -0.900866 0.00010992 2.76846 11.0986 0.00640696 -3.42785 -5 2 -1.40977 0.795072 2.93807 -5.57817 -3.04583 1.75974 -6 2 -1.40852 -0.795411 2.93919 -5.58301 3.03943 1.75548 -ITEM: TIMESTEP -40 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0269208 -0.00114842 0.00674288 5.42877 0.00730481 4.31748 -2 2 -0.171607 -0.000594964 0.954009 -8.40692 -0.00484075 2.50346 -3 2 0.92209 -0.000466908 -0.0840066 2.3456 -0.00296432 -6.82561 -4 1 -0.895716 0.000110956 2.76419 -6.18264 -0.00259137 3.07323 -5 2 -1.45218 0.754436 2.95353 3.40261 6.39649 -1.53879 -6 2 -1.45099 -0.75482 2.9546 3.41259 -6.3934 -1.52976 -ITEM: TIMESTEP -50 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0239329 -0.00114175 0.0128926 -8.15007 -0.014184 -11.0504 -2 2 -0.230937 -0.000644481 0.949766 5.72493 0.00756591 4.36142 -3 2 0.91871 -0.000511822 -0.144074 2.40885 0.00639366 6.3907 -4 1 -0.899724 0.000108594 2.76531 11.5106 0.00694105 -3.03119 -5 2 -1.41275 0.792848 2.92798 -5.74551 -2.08247 1.6662 -6 2 -1.41151 -0.793206 2.9291 -5.7488 2.07576 1.66327 -ITEM: TIMESTEP -60 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0287434 -0.0011479 0.00953424 6.82379 0.00862743 4.63675 -2 2 -0.180318 -0.000600308 0.956082 -8.03241 -0.00482631 2.10983 -3 2 0.922397 -0.000459471 -0.0739414 0.782565 -0.00412295 -6.72684 -4 1 -0.892694 0.000113827 2.76489 -6.55004 -0.00361317 2.26756 -5 2 -1.45749 0.757284 2.91975 3.48398 5.14308 -1.14726 -6 2 -1.4563 -0.757724 2.92081 3.49211 -5.13915 -1.14003 -ITEM: TIMESTEP -70 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.025848 -0.00114271 0.0136758 -6.10179 -0.0106002 -8.24377 -2 2 -0.259382 -0.000669072 0.94681 6.59121 0.0065405 1.93161 -3 2 0.923692 -0.000484045 -0.110366 -0.0484081 0.00428029 6.1322 -4 1 -0.894893 0.000114175 2.76783 7.43985 0.00424265 -2.1131 -5 2 -1.42416 0.79251 2.88639 -3.9377 -3.53776 1.14903 -6 2 -1.42292 -0.792944 2.88751 -3.94318 3.53329 1.14403 -ITEM: TIMESTEP -80 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.030135 -0.00114891 0.00965506 7.41429 0.0123912 9.3266 -2 2 -0.213346 -0.000627628 0.954378 -6.76672 -0.00675668 -2.04974 -3 2 0.924938 -0.000432456 -0.0385785 -0.591495 -0.00546702 -7.10385 -4 1 -0.888796 0.000119275 2.76827 -9.03539 -0.00642914 1.05959 -5 2 -1.46214 0.762697 2.87512 4.48797 2.10983 -0.617778 -6 2 -1.46094 -0.763208 2.87619 4.49133 -2.10357 -0.61482 -ITEM: TIMESTEP -90 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0270206 -0.00114299 0.0145983 -6.11813 -0.00811207 -4.69194 -2 2 -0.274281 -0.000680382 0.947366 7.50569 0.00503125 -1.23144 -3 2 0.92514 -0.000469353 -0.0912836 -0.650877 0.00352314 5.72916 -4 1 -0.891964 0.000116952 2.76852 3.17186 0.0014363 -1.52231 -5 2 -1.43137 0.791127 2.86377 -1.95059 -4.67792 0.861555 -6 2 -1.43013 -0.791605 2.86488 -1.95795 4.67604 0.85497 -ITEM: TIMESTEP -100 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.030669 -0.00114759 0.0121427 6.42493 0.0120997 10.0073 -2 2 -0.203569 -0.000615753 0.960107 -6.40597 -0.00736639 -3.30674 -3 2 0.923036 -0.000442107 -0.0503324 -0.0528607 -0.00477186 -6.71539 -4 1 -0.889443 0.000116814 2.76553 -7.7691 -0.0050422 1.37075 -5 2 -1.45671 0.76736 2.88018 3.9012 0.426437 -0.678284 -6 2 -1.4555 -0.767854 2.88126 3.9018 -0.421357 -0.677675 diff --git a/examples/amoeba/dump.water_dimer.hippo.1.test b/examples/amoeba/dump.water_dimer.hippo.1.test deleted file mode 100644 index 854055cac8..0000000000 --- a/examples/amoeba/dump.water_dimer.hippo.1.test +++ /dev/null @@ -1,165 +0,0 @@ -ITEM: TIMESTEP -0 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.024616 -0.001154 -0.003748 6.77815 0.012441 10.1043 -2 2 -0.244211 -0.000666 0.933978 -6.4757 -0.0067894 -2.41462 -3 2 0.932234 -0.000406 -0.008705 -0.41382 -0.00540908 -7.21892 -4 1 -0.892721 0.00012 2.77367 -11.9286 -0.00716387 3.29032 -5 2 -1.463 0.75512 2.93387 6.01759 3.00398 -1.88265 -6 2 -1.46181 -0.755549 2.93493 6.02238 -2.99706 -1.87845 -ITEM: TIMESTEP -10 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0215682 -0.00114805 0.0012979 -6.21268 -0.00924301 -6.19628 -2 2 -0.293095 -0.000710409 0.925512 6.99875 0.0060121 0.73377 -3 2 0.933101 -0.000449223 -0.0710512 -0.501529 0.00371221 5.82975 -4 1 -0.897884 0.000116793 2.77488 7.53966 0.00410482 -2.48587 -5 2 -1.42223 0.790989 2.91963 -3.9083 -4.87571 1.06275 -6 2 -1.42099 -0.791374 2.92075 -3.91591 4.87112 1.05588 -ITEM: TIMESTEP -20 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0258564 -0.00115245 -0.000173159 6.03126 0.0103631 7.9915 -2 2 -0.214264 -0.000636469 0.942735 -7.00136 -0.00592601 -0.60904 -3 2 0.929001 -0.000430037 -0.0392653 0.701856 -0.0043552 -6.96821 -4 1 -0.893054 0.000118973 2.77259 -8.83712 -0.00512625 2.54445 -5 2 -1.46387 0.753541 2.92502 4.54888 4.85296 -1.48277 -6 2 -1.46268 -0.753984 2.92608 4.55648 -4.84791 -1.47593 -ITEM: TIMESTEP -30 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0237238 -0.00114526 0.00766999 -7.81865 -0.0119879 -8.3015 -2 2 -0.241061 -0.000656856 0.943727 6.09288 0.0066852 2.69388 -3 2 0.923032 -0.000493736 -0.123121 1.75879 0.00552582 5.88556 -4 1 -0.897978 0.000115451 2.77309 11.6501 0.00727223 -2.82116 -5 2 -1.42536 0.788259 2.90023 -5.83991 -2.07218 1.27305 -6 2 -1.42412 -0.788676 2.90134 -5.84324 2.06468 1.27016 -ITEM: TIMESTEP -40 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0292005 -0.00114894 0.00855106 5.6712 0.00787804 4.86214 -2 2 -0.153199 -0.000576377 0.959922 -7.58451 -0.00449199 2.07976 -3 2 0.919336 -0.000480028 -0.0995905 1.37912 -0.00359093 -6.63778 -4 1 -0.89217 0.000118771 2.77132 -5.68638 -0.00321013 1.64962 -5 2 -1.47004 0.751887 2.88738 3.10503 6.73714 -0.981624 -6 2 -1.46886 -0.752392 2.88844 3.11554 -6.73373 -0.972121 -ITEM: TIMESTEP -50 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0276682 -0.00114169 0.0171537 -7.90829 -0.012452 -8.85967 -2 2 -0.185755 -0.000598779 0.964286 5.83022 0.00671605 3.0354 -3 2 0.908646 -0.000541992 -0.175729 1.96931 0.00577867 6.00768 -4 1 -0.895573 0.00011689 2.77245 11.8261 0.00822001 -1.54401 -5 2 -1.4336 0.787999 2.84603 -5.85703 -2.08185 0.681764 -6 2 -1.43237 -0.788505 2.84714 -5.86031 2.07358 0.678838 -ITEM: TIMESTEP -60 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0340777 -0.00114581 0.0184647 7.2272 0.00951667 5.4479 -2 2 -0.113434 -0.000533921 0.975674 -7.44659 -0.00496006 1.26816 -3 2 0.909471 -0.000512535 -0.134923 -0.287426 -0.00476073 -6.43846 -4 1 -0.888126 0.000122907 2.77269 -9.08281 -0.00670232 0.725333 -5 2 -1.47838 0.753365 2.8077 4.79099 4.82306 -0.504859 -6 2 -1.47719 -0.753996 2.80876 4.79863 -4.81616 -0.498076 -ITEM: TIMESTEP -70 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0329631 -0.00113896 0.0269437 -6.82209 -0.00981599 -6.32682 -2 2 -0.16378 -0.000570078 0.980622 6.44654 0.00529861 0.332147 -3 2 0.899135 -0.000560623 -0.191768 0.56204 0.00474764 6.11404 -4 1 -0.890774 0.0001215 2.77364 7.6207 0.00561833 -0.364449 -5 2 -1.4359 0.790393 2.75878 -3.89983 -4.84574 0.12595 -6 2 -1.43466 -0.791026 2.7599 -3.90736 4.83989 0.11913 -ITEM: TIMESTEP -80 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0396799 -0.00114299 0.0287108 8.10782 0.0121934 8.26954 -2 2 -0.101327 -0.000514632 0.989821 -6.98655 -0.00644087 -1.35375 -3 2 0.902079 -0.000521504 -0.139604 -1.23495 -0.0056704 -6.67396 -4 1 -0.883488 0.000127321 2.77377 -12.2256 -0.0109573 -1.83848 -5 2 -1.47309 0.755263 2.71301 6.16734 2.89071 0.796293 -6 2 -1.4719 -0.756019 2.71407 6.17192 -2.87983 0.800362 -ITEM: TIMESTEP -90 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0383179 -0.00113532 0.0380883 -7.16334 -0.00889532 -4.6369 -2 2 -0.149498 -0.00054848 0.995531 6.83221 0.00448143 -1.26419 -3 2 0.889431 -0.00057205 -0.197356 0.916 0.00477871 5.76452 -4 1 -0.886952 0.000122589 2.77093 7.29365 0.00587785 0.155791 -5 2 -1.42602 0.790491 2.68716 -3.93543 -4.86013 -0.00619146 -6 2 -1.42478 -0.791209 2.68827 -3.94309 4.85389 -0.0130349 -ITEM: TIMESTEP -100 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0443853 -0.00113803 0.0410221 7.36858 0.0108291 7.15279 -2 2 -0.076648 -0.000485983 1.00287 -6.96363 -0.00585609 -0.543819 -3 2 0.890615 -0.000542732 -0.157107 -0.3904 -0.00504823 -6.73186 -4 1 -0.880834 0.000124898 2.7674 -9.13947 -0.00841726 -1.90715 -5 2 -1.46341 0.754149 2.66816 4.55895 4.52404 1.01184 -6 2 -1.46222 -0.754952 2.66922 4.56597 -4.51554 1.01819 diff --git a/examples/amoeba/dump.water_dimer.hippo.4.test b/examples/amoeba/dump.water_dimer.hippo.4.test deleted file mode 100644 index 854055cac8..0000000000 --- a/examples/amoeba/dump.water_dimer.hippo.4.test +++ /dev/null @@ -1,165 +0,0 @@ -ITEM: TIMESTEP -0 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.024616 -0.001154 -0.003748 6.77815 0.012441 10.1043 -2 2 -0.244211 -0.000666 0.933978 -6.4757 -0.0067894 -2.41462 -3 2 0.932234 -0.000406 -0.008705 -0.41382 -0.00540908 -7.21892 -4 1 -0.892721 0.00012 2.77367 -11.9286 -0.00716387 3.29032 -5 2 -1.463 0.75512 2.93387 6.01759 3.00398 -1.88265 -6 2 -1.46181 -0.755549 2.93493 6.02238 -2.99706 -1.87845 -ITEM: TIMESTEP -10 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0215682 -0.00114805 0.0012979 -6.21268 -0.00924301 -6.19628 -2 2 -0.293095 -0.000710409 0.925512 6.99875 0.0060121 0.73377 -3 2 0.933101 -0.000449223 -0.0710512 -0.501529 0.00371221 5.82975 -4 1 -0.897884 0.000116793 2.77488 7.53966 0.00410482 -2.48587 -5 2 -1.42223 0.790989 2.91963 -3.9083 -4.87571 1.06275 -6 2 -1.42099 -0.791374 2.92075 -3.91591 4.87112 1.05588 -ITEM: TIMESTEP -20 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0258564 -0.00115245 -0.000173159 6.03126 0.0103631 7.9915 -2 2 -0.214264 -0.000636469 0.942735 -7.00136 -0.00592601 -0.60904 -3 2 0.929001 -0.000430037 -0.0392653 0.701856 -0.0043552 -6.96821 -4 1 -0.893054 0.000118973 2.77259 -8.83712 -0.00512625 2.54445 -5 2 -1.46387 0.753541 2.92502 4.54888 4.85296 -1.48277 -6 2 -1.46268 -0.753984 2.92608 4.55648 -4.84791 -1.47593 -ITEM: TIMESTEP -30 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0237238 -0.00114526 0.00766999 -7.81865 -0.0119879 -8.3015 -2 2 -0.241061 -0.000656856 0.943727 6.09288 0.0066852 2.69388 -3 2 0.923032 -0.000493736 -0.123121 1.75879 0.00552582 5.88556 -4 1 -0.897978 0.000115451 2.77309 11.6501 0.00727223 -2.82116 -5 2 -1.42536 0.788259 2.90023 -5.83991 -2.07218 1.27305 -6 2 -1.42412 -0.788676 2.90134 -5.84324 2.06468 1.27016 -ITEM: TIMESTEP -40 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0292005 -0.00114894 0.00855106 5.6712 0.00787804 4.86214 -2 2 -0.153199 -0.000576377 0.959922 -7.58451 -0.00449199 2.07976 -3 2 0.919336 -0.000480028 -0.0995905 1.37912 -0.00359093 -6.63778 -4 1 -0.89217 0.000118771 2.77132 -5.68638 -0.00321013 1.64962 -5 2 -1.47004 0.751887 2.88738 3.10503 6.73714 -0.981624 -6 2 -1.46886 -0.752392 2.88844 3.11554 -6.73373 -0.972121 -ITEM: TIMESTEP -50 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0276682 -0.00114169 0.0171537 -7.90829 -0.012452 -8.85967 -2 2 -0.185755 -0.000598779 0.964286 5.83022 0.00671605 3.0354 -3 2 0.908646 -0.000541992 -0.175729 1.96931 0.00577867 6.00768 -4 1 -0.895573 0.00011689 2.77245 11.8261 0.00822001 -1.54401 -5 2 -1.4336 0.787999 2.84603 -5.85703 -2.08185 0.681764 -6 2 -1.43237 -0.788505 2.84714 -5.86031 2.07358 0.678838 -ITEM: TIMESTEP -60 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0340777 -0.00114581 0.0184647 7.2272 0.00951667 5.4479 -2 2 -0.113434 -0.000533921 0.975674 -7.44659 -0.00496006 1.26816 -3 2 0.909471 -0.000512535 -0.134923 -0.287426 -0.00476073 -6.43846 -4 1 -0.888126 0.000122907 2.77269 -9.08281 -0.00670232 0.725333 -5 2 -1.47838 0.753365 2.8077 4.79099 4.82306 -0.504859 -6 2 -1.47719 -0.753996 2.80876 4.79863 -4.81616 -0.498076 -ITEM: TIMESTEP -70 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0329631 -0.00113896 0.0269437 -6.82209 -0.00981599 -6.32682 -2 2 -0.16378 -0.000570078 0.980622 6.44654 0.00529861 0.332147 -3 2 0.899135 -0.000560623 -0.191768 0.56204 0.00474764 6.11404 -4 1 -0.890774 0.0001215 2.77364 7.6207 0.00561833 -0.364449 -5 2 -1.4359 0.790393 2.75878 -3.89983 -4.84574 0.12595 -6 2 -1.43466 -0.791026 2.7599 -3.90736 4.83989 0.11913 -ITEM: TIMESTEP -80 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0396799 -0.00114299 0.0287108 8.10782 0.0121934 8.26954 -2 2 -0.101327 -0.000514632 0.989821 -6.98655 -0.00644087 -1.35375 -3 2 0.902079 -0.000521504 -0.139604 -1.23495 -0.0056704 -6.67396 -4 1 -0.883488 0.000127321 2.77377 -12.2256 -0.0109573 -1.83848 -5 2 -1.47309 0.755263 2.71301 6.16734 2.89071 0.796293 -6 2 -1.4719 -0.756019 2.71407 6.17192 -2.87983 0.800362 -ITEM: TIMESTEP -90 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0383179 -0.00113532 0.0380883 -7.16334 -0.00889532 -4.6369 -2 2 -0.149498 -0.00054848 0.995531 6.83221 0.00448143 -1.26419 -3 2 0.889431 -0.00057205 -0.197356 0.916 0.00477871 5.76452 -4 1 -0.886952 0.000122589 2.77093 7.29365 0.00587785 0.155791 -5 2 -1.42602 0.790491 2.68716 -3.93543 -4.86013 -0.00619146 -6 2 -1.42478 -0.791209 2.68827 -3.94309 4.85389 -0.0130349 -ITEM: TIMESTEP -100 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0443853 -0.00113803 0.0410221 7.36858 0.0108291 7.15279 -2 2 -0.076648 -0.000485983 1.00287 -6.96363 -0.00585609 -0.543819 -3 2 0.890615 -0.000542732 -0.157107 -0.3904 -0.00504823 -6.73186 -4 1 -0.880834 0.000124898 2.7674 -9.13947 -0.00841726 -1.90715 -5 2 -1.46341 0.754149 2.66816 4.55895 4.52404 1.01184 -6 2 -1.46222 -0.754952 2.66922 4.56597 -4.51554 1.01819 diff --git a/examples/amoeba/dump.water_hexamer.amoeba.1.test b/examples/amoeba/dump.water_hexamer.amoeba.1.test deleted file mode 100644 index 88e888cc45..0000000000 --- a/examples/amoeba/dump.water_hexamer.amoeba.1.test +++ /dev/null @@ -1,297 +0,0 @@ -ITEM: TIMESTEP -0 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.50217 -0.191359 1.43493 15.8836 -7.45837 3.84323 -2 2 -0.601054 -0.596972 1.55372 -22.9153 9.01978 -0.990133 -3 2 -2.0067 -0.422327 2.21985 1.01155 0.118537 -0.791932 -4 1 -1.74457 -0.382348 -1.30914 -6.66041 -3.92202 8.41554 -5 2 -1.88894 -0.479653 -0.347624 4.77968 3.15053 -8.64245 -6 2 -2.51683 -0.766765 -1.73377 2.90782 1.57916 -0.744558 -7 1 -0.560409 2.01783 -0.121984 -13.2194 -12.8195 1.43178 -8 2 -0.94772 1.53357 0.625228 6.08473 6.021 -1.58068 -9 2 -0.989831 1.59274 -0.877419 5.83415 5.52991 -0.337029 -10 1 0.964803 -1.16576 1.43999 12.6547 2.88136 -21.3636 -11 2 0.979557 -1.52204 0.527833 -3.6968 -1.92725 12.6575 -12 2 1.54222 -0.393692 1.34437 -3.37883 -2.73031 5.998 -13 1 0.974705 -1.4015 -1.33597 -6.12193 14.8514 -0.790538 -14 2 0.065161 -1.11895 -1.52289 4.56017 -6.05436 1.71545 -15 2 1.47071 -0.570933 -1.27771 1.31912 -7.40942 1.06098 -16 1 2.00228 1.05782 -0.124502 -10.3736 10.8414 -1.12005 -17 2 1.14164 1.53227 -0.140121 11.8812 -8.20067 0.772116 -18 2 2.67472 1.73534 -0.237995 -0.550493 -3.47117 0.466398 -ITEM: TIMESTEP -10 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.50661 -0.189383 1.4364 14.5938 -8.99605 8.72579 -2 2 -0.616993 -0.604745 1.5716 -17.7352 9.03346 -4.01613 -3 2 -2.01184 -0.421588 2.22126 -0.664878 1.39015 -2.52743 -4 1 -1.74564 -0.383429 -1.31051 0.451442 -0.432875 3.71075 -5 2 -1.85676 -0.451272 -0.342641 -1.17801 0.27861 -9.12816 -6 2 -2.51648 -0.764704 -1.74119 1.00433 0.523826 3.94489 -7 1 -0.565581 2.01415 -0.121947 -0.431671 0.816258 1.37224 -8 2 -0.923503 1.54613 0.649943 -0.836345 -0.35076 -8.91816 -9 2 -0.954982 1.61593 -0.9136 -0.398984 -1.29665 6.9827 -10 1 0.971315 -1.16462 1.43403 2.66632 -4.10463 -4.1745 -11 2 0.960388 -1.57587 0.54557 3.80791 8.56867 8.0783 -12 2 1.545 -0.38505 1.37422 -2.3984 -5.62816 -5.66197 -13 1 0.972827 -1.39712 -1.33549 -1.10638 0.442925 0.267527 -14 2 0.0526434 -1.14464 -1.51395 7.06933 2.8298 1.48943 -15 2 1.50554 -0.590868 -1.25662 -6.54392 -2.53639 -0.258333 -16 1 2.00275 1.0584 -0.124848 -7.13185 5.38221 -0.0306111 -17 2 1.13969 1.52381 -0.134074 11.7308 -4.5992 -0.113372 -18 2 2.68869 1.72277 -0.237084 -2.89819 -1.32119 0.257039 -ITEM: TIMESTEP -20 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.51649 -0.18584 1.44395 5.65501 -4.20149 4.07802 -2 2 -0.637196 -0.60535 1.5789 -10.2535 4.51311 -0.350867 -3 2 -2.05196 -0.408647 2.21473 3.52072 0.575858 -3.20585 -4 1 -1.74216 -0.383007 -1.31779 -5.65244 -1.7459 7.46957 -5 2 -1.85838 -0.422286 -0.35262 3.57624 0.698487 -5.03248 -6 2 -2.53778 -0.772973 -1.68856 2.62304 1.05785 -2.46299 -7 1 -0.568621 2.01502 -0.121788 -7.49291 -10.5083 -0.07078 -8 2 -0.953332 1.50031 0.601729 3.90339 5.1027 1.32659 -9 2 -0.948304 1.59097 -0.90055 3.2198 4.86429 -1.5712 -10 1 0.981527 -1.16776 1.43139 8.19382 2.30469 -14.0571 -11 2 0.999682 -1.57682 0.548153 -4.17545 -1.46604 7.90595 -12 2 1.55686 -0.401102 1.29785 -3.41945 -1.35828 5.31582 -13 1 0.971997 -1.39727 -1.33295 -3.50737 11.1512 0.685267 -14 2 0.0679408 -1.0929 -1.49373 1.59713 -5.72522 -0.144088 -15 2 1.47933 -0.582056 -1.22295 2.04209 -4.76253 -0.234646 -16 1 2.00557 1.05551 -0.12468 -4.4992 7.40197 -0.448564 -17 2 1.16008 1.5422 -0.129327 5.1837 -4.83397 0.46283 -18 2 2.69054 1.72007 -0.238059 -0.51465 -3.06849 0.334482 -ITEM: TIMESTEP -30 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.52872 -0.18011 1.45173 -0.933277 -2.21949 5.98424 -2 2 -0.665459 -0.602256 1.60472 0.633036 0.719099 -1.22127 -3 2 -2.07366 -0.404666 2.21589 2.60377 1.4581 -4.42661 -4 1 -1.74225 -0.382648 -1.3226 2.4731 1.57235 -0.799694 -5 2 -1.81423 -0.398932 -0.35676 -3.06045 -1.92828 -1.63228 -6 2 -2.5352 -0.77665 -1.69294 0.0233925 -0.139311 2.03217 -7 1 -0.576286 2.0073 -0.122823 5.68391 5.42307 0.543301 -8 2 -0.95235 1.50691 0.611905 -2.48677 -2.29116 -3.6455 -9 2 -0.915502 1.63076 -0.941481 -3.12923 -3.02599 2.90572 -10 1 0.998541 -1.16996 1.42191 -2.76709 -0.0175982 4.85417 -11 2 0.970261 -1.63876 0.575717 2.4618 4.28015 -0.493825 -12 2 1.54742 -0.386783 1.27666 -1.41861 -3.70889 -3.67396 -13 1 0.969317 -1.3895 -1.32829 2.03562 -5.48364 0.295138 -14 2 0.0583035 -1.11723 -1.49206 1.73159 3.49229 -0.0543931 -15 2 1.50655 -0.600283 -1.19205 -3.9925 1.94925 -1.04523 -16 1 2.00848 1.05446 -0.124132 1.88868 -1.58075 0.754117 -17 2 1.16959 1.53865 -0.11771 0.573913 1.34283 -0.58573 -18 2 2.71517 1.69464 -0.239075 -2.32089 0.157967 0.209615 -ITEM: TIMESTEP -40 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.53726 -0.175397 1.46121 -7.56641 2.45844 -0.518817 -2 2 -0.675238 -0.584022 1.60915 7.85196 -3.99237 1.67217 -3 2 -2.08862 -0.402087 2.21789 3.0617 0.39778 -2.04562 -4 1 -1.73949 -0.379604 -1.32819 -2.36016 -0.787528 -0.0315325 -5 2 -1.83346 -0.428429 -0.37056 1.90026 0.717301 4.17358 -6 2 -2.53017 -0.786871 -1.68316 0.151557 -0.108901 -3.75615 -7 1 -0.576955 2.0043 -0.124416 -0.431513 -1.54355 -1.46354 -8 2 -0.992092 1.48382 0.567817 1.09284 0.418387 6.78235 -9 2 -0.944746 1.62819 -0.925975 0.76441 1.37882 -5.22407 -10 1 1.00941 -1.17308 1.4189 -1.85973 4.64458 1.0889 -11 2 0.973659 -1.6403 0.580693 -1.69219 -4.78957 -3.29195 -12 2 1.53559 -0.396477 1.19908 0.544307 1.46508 3.63166 -13 1 0.969009 -1.38744 -1.3228 -0.275569 1.85307 -0.63583 -14 2 0.0737932 -1.09141 -1.50366 -4.66851 -2.83882 -1.16892 -15 2 1.46633 -0.576681 -1.19175 5.00795 0.70617 0.521536 -16 1 2.01183 1.05054 -0.121932 4.41526 -1.70685 -0.0836272 -17 2 1.19121 1.55327 -0.120038 -7.25224 2.19125 0.154184 -18 2 2.71636 1.68982 -0.237383 1.31607 -0.463304 0.195666 -ITEM: TIMESTEP -50 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.53986 -0.172749 1.46865 -10.3641 5.96951 -4.41562 -2 2 -0.678724 -0.568486 1.60775 14.9207 -7.13278 2.04782 -3 2 -2.07217 -0.405364 2.23045 -0.725799 -0.490948 1.77161 -4 1 -1.74113 -0.378171 -1.32957 5.99712 2.85952 -9.13842 -5 2 -1.82713 -0.447378 -0.375703 -3.89226 -1.3818 7.11516 -6 2 -2.4999 -0.790471 -1.74187 -3.02333 -1.60416 1.77146 -7 1 -0.579496 1.99691 -0.128028 9.72738 10.7655 -0.463519 -8 2 -0.97832 1.50522 0.591572 -4.4866 -5.64841 2.33138 -9 2 -0.951447 1.66071 -0.944057 -3.97244 -4.92262 -1.79974 -10 1 1.01358 -1.17192 1.41393 -6.48605 2.83151 13.495 -11 2 0.960671 -1.668 0.598799 0.887838 -3.18341 -9.75086 -12 2 1.53449 -0.394669 1.19537 2.46945 2.14925 -1.89795 -13 1 0.966791 -1.38037 -1.31946 4.73561 -12.449 -1.17286 -14 2 0.0653014 -1.12956 -1.52441 -4.76491 5.51904 -0.304595 -15 2 1.48076 -0.580834 -1.19775 0.0522693 6.36707 0.249418 -16 1 2.01309 1.04924 -0.119438 7.79557 -11.0594 0.778107 -17 2 1.18753 1.53519 -0.124654 -9.57007 7.63584 -0.456674 -18 2 2.72824 1.67508 -0.226016 0.699647 3.77524 -0.159727 -ITEM: TIMESTEP -60 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.535 -0.173529 1.47468 -12.8115 9.37187 -10.8344 -2 2 -0.673508 -0.564245 1.59147 19.3914 -9.12777 2.73797 -3 2 -2.04099 -0.404174 2.24807 -3.82175 -1.70255 6.71674 -4 1 -1.73996 -0.376347 -1.33351 0.570165 0.280665 -6.43548 -5 2 -1.87928 -0.466718 -0.390362 1.26398 0.876645 10.7815 -6 2 -2.48657 -0.801116 -1.75201 -2.14828 -1.00411 -3.66812 -7 1 -0.576718 1.99595 -0.131852 3.14419 3.30092 -1.47913 -8 2 -0.97416 1.49195 0.577492 -1.32391 -2.58987 8.72867 -9 2 -0.983297 1.63168 -0.91691 -0.334419 -0.770035 -7.07098 -10 1 1.00791 -1.1681 1.41401 -6.20027 1.07549 12.575 -11 2 0.972875 -1.65454 0.593802 -0.476084 -5.46772 -10.3478 -12 2 1.54632 -0.404877 1.20306 3.83119 5.88484 -0.834958 -13 1 0.966385 -1.38017 -1.32091 1.49436 -4.60495 -1.57148 -14 2 0.0722824 -1.10128 -1.51274 -8.16812 -0.531008 -1.13308 -15 2 1.45394 -0.565765 -1.20718 7.01226 4.42564 1.66198 -16 1 2.01308 1.04537 -0.116618 6.94232 -7.944 0.350248 -17 2 1.19126 1.53332 -0.135036 -13.3157 5.74475 0.221956 -18 2 2.70715 1.69348 -0.205764 4.95008 2.7812 -0.398561 -ITEM: TIMESTEP -70 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.52447 -0.177745 1.47754 -14.009 12.5988 -14.9127 -2 2 -0.663619 -0.56979 1.57126 20.9018 -10.2143 3.8986 -3 2 -2.00537 -0.388653 2.26816 -5.41735 -2.91391 10.0958 -4 1 -1.74327 -0.377755 -1.33511 7.69657 4.1782 -9.73798 -5 2 -1.88018 -0.439682 -0.388162 -4.07322 -2.33918 9.17346 -6 2 -2.47021 -0.801057 -1.79014 -4.11028 -2.07522 1.70143 -7 1 -0.576352 1.99233 -0.135801 8.33914 8.33997 -1.40304 -8 2 -0.93279 1.50467 0.607511 -5.01196 -5.05095 3.69276 -9 2 -0.967697 1.61396 -0.924499 -2.96791 -3.60448 -2.11522 -10 1 0.996682 -1.16249 1.41603 -5.52393 -2.7768 9.00886 -11 2 0.982553 -1.62276 0.577115 -1.00274 -4.80219 -7.71302 -12 2 1.55168 -0.404501 1.24312 4.97383 8.09577 -0.603791 -13 1 0.964232 -1.37715 -1.32734 3.83388 -12.0598 -0.0980446 -14 2 0.0575072 -1.10802 -1.48098 -4.628 4.85469 -1.01689 -15 2 1.48931 -0.58697 -1.19891 1.1914 7.02562 -0.119366 -16 1 2.01083 1.04528 -0.114231 6.83173 -12.9986 1.26494 -17 2 1.17034 1.50303 -0.133551 -9.79274 8.34256 -0.476042 -18 2 2.7022 1.69874 -0.182183 2.76884 5.3999 -0.639748 -ITEM: TIMESTEP -80 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.51177 -0.182537 1.47592 -13.1365 10.3139 -11.8951 -2 2 -0.654143 -0.583091 1.57918 18.6975 -8.17701 1.44433 -3 2 -1.97348 -0.365352 2.2852 -6.58467 -1.56222 9.05296 -4 1 -1.74352 -0.377279 -1.33693 -0.505822 0.308788 -3.25308 -5 2 -1.91188 -0.438855 -0.39405 1.95743 0.358158 9.20234 -6 2 -2.48397 -0.807922 -1.76244 -1.16931 -0.70018 -3.86005 -7 1 -0.571778 1.99034 -0.138544 1.3921 0.315501 -1.43854 -8 2 -0.938419 1.50232 0.602337 -1.22478 -1.30903 4.8686 -9 2 -0.959599 1.56918 -0.90914 -0.0288155 0.574454 -3.52808 -10 1 0.985435 -1.15713 1.41811 -6.25848 -6.25702 9.27302 -11 2 0.972167 -1.59168 0.560031 1.69554 -0.201305 -5.06875 -12 2 1.54032 -0.386652 1.30283 4.96928 5.72762 -4.15176 -13 1 0.963614 -1.3793 -1.33436 0.183354 -1.1048 0.823621 -14 2 0.065336 -1.06423 -1.45856 -4.4409 -1.33366 -2.05511 -15 2 1.49256 -0.587857 -1.21654 4.36346 2.23441 0.338535 -16 1 2.00803 1.04345 -0.110717 3.61274 -3.25471 0.639326 -17 2 1.16919 1.51061 -0.133404 -8.46417 2.50048 0.10369 -18 2 2.67828 1.72068 -0.16597 4.94198 1.56662 -0.49597 -ITEM: TIMESTEP -90 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.50159 -0.186388 1.47232 -10.1666 8.56134 -9.06842 -2 2 -0.637201 -0.589948 1.58141 9.00709 -5.13609 3.43504 -3 2 -1.97805 -0.327506 2.28752 -1.76215 -2.05269 5.01359 -4 1 -1.7485 -0.377921 -1.33249 5.81313 3.27044 -5.4853 -5 2 -1.87141 -0.433051 -0.37781 -3.50795 -2.5324 4.09176 -6 2 -2.48522 -0.804273 -1.77362 -2.18894 -1.0456 2.79096 -7 1 -0.568425 1.98378 -0.140489 1.33268 1.60885 -0.760228 -8 2 -0.945484 1.51375 0.61188 -1.03442 -1.79649 -0.570033 -9 2 -0.936389 1.56212 -0.924193 -1.07342 -0.200973 1.02154 -10 1 0.975854 -1.15481 1.42351 1.86741 -2.52595 -4.21318 -11 2 0.98193 -1.53917 0.537259 -2.6087 -4.02599 1.03016 -12 2 1.52752 -0.379325 1.30866 2.98513 5.11632 2.51897 -13 1 0.962056 -1.37771 -1.33914 1.58342 -3.36145 0.893222 -14 2 0.0608833 -1.06855 -1.4877 0.530861 1.7595 -0.414339 -15 2 1.52774 -0.603203 -1.25083 -2.15602 1.98356 -0.537593 -16 1 2.00483 1.04652 -0.10624 2.44039 -5.05754 0.604689 -17 2 1.15126 1.49959 -0.126569 -0.261743 3.34267 -0.115684 -18 2 2.69252 1.71134 -0.15978 -0.800158 2.09248 -0.235157 -ITEM: TIMESTEP -100 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.49915 -0.184572 1.46491 -1.64286 -0.923423 4.11541 -2 2 -0.634606 -0.601439 1.61658 -0.503947 1.48506 -2.91046 -3 2 -1.9835 -0.312527 2.28463 -1.23961 0.673264 -1.96712 -4 1 -1.74898 -0.375873 -1.32741 -4.05983 -3.09974 1.92324 -5 2 -1.86884 -0.471305 -0.372769 3.24632 2.33491 1.76011 -6 2 -2.50916 -0.806172 -1.72327 1.14638 0.924599 -3.12385 -7 1 -0.564884 1.97778 -0.142101 -4.14881 -3.0738 -0.168062 -8 2 -0.958996 1.4911 0.595477 2.25574 1.20147 -1.85844 -9 2 -0.937749 1.56372 -0.930264 1.31445 2.00952 1.76263 -10 1 0.975211 -1.15256 1.42364 -0.947501 -4.6035 2.62584 -11 2 0.950951 -1.55837 0.541757 3.10583 4.89391 1.85772 -12 2 1.52342 -0.363228 1.34082 0.672959 -1.69053 -5.30235 -13 1 0.962361 -1.37851 -1.34242 -1.40487 6.54708 -1.50719 -14 2 0.0703818 -1.05861 -1.53269 1.44041 -3.14031 1.12109 -15 2 1.51335 -0.586474 -1.29057 -0.612624 -3.69916 1.63647 -16 1 2.00445 1.04687 -0.100669 -1.02523 8.04786 -0.336895 -17 2 1.16075 1.52969 -0.119062 2.24423 -4.67525 0.190963 -18 2 2.68635 1.72058 -0.160395 0.158945 -3.21195 0.180894 diff --git a/examples/amoeba/dump.water_hexamer.amoeba.4.test b/examples/amoeba/dump.water_hexamer.amoeba.4.test deleted file mode 100644 index 88e888cc45..0000000000 --- a/examples/amoeba/dump.water_hexamer.amoeba.4.test +++ /dev/null @@ -1,297 +0,0 @@ -ITEM: TIMESTEP -0 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.50217 -0.191359 1.43493 15.8836 -7.45837 3.84323 -2 2 -0.601054 -0.596972 1.55372 -22.9153 9.01978 -0.990133 -3 2 -2.0067 -0.422327 2.21985 1.01155 0.118537 -0.791932 -4 1 -1.74457 -0.382348 -1.30914 -6.66041 -3.92202 8.41554 -5 2 -1.88894 -0.479653 -0.347624 4.77968 3.15053 -8.64245 -6 2 -2.51683 -0.766765 -1.73377 2.90782 1.57916 -0.744558 -7 1 -0.560409 2.01783 -0.121984 -13.2194 -12.8195 1.43178 -8 2 -0.94772 1.53357 0.625228 6.08473 6.021 -1.58068 -9 2 -0.989831 1.59274 -0.877419 5.83415 5.52991 -0.337029 -10 1 0.964803 -1.16576 1.43999 12.6547 2.88136 -21.3636 -11 2 0.979557 -1.52204 0.527833 -3.6968 -1.92725 12.6575 -12 2 1.54222 -0.393692 1.34437 -3.37883 -2.73031 5.998 -13 1 0.974705 -1.4015 -1.33597 -6.12193 14.8514 -0.790538 -14 2 0.065161 -1.11895 -1.52289 4.56017 -6.05436 1.71545 -15 2 1.47071 -0.570933 -1.27771 1.31912 -7.40942 1.06098 -16 1 2.00228 1.05782 -0.124502 -10.3736 10.8414 -1.12005 -17 2 1.14164 1.53227 -0.140121 11.8812 -8.20067 0.772116 -18 2 2.67472 1.73534 -0.237995 -0.550493 -3.47117 0.466398 -ITEM: TIMESTEP -10 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.50661 -0.189383 1.4364 14.5938 -8.99605 8.72579 -2 2 -0.616993 -0.604745 1.5716 -17.7352 9.03346 -4.01613 -3 2 -2.01184 -0.421588 2.22126 -0.664878 1.39015 -2.52743 -4 1 -1.74564 -0.383429 -1.31051 0.451442 -0.432875 3.71075 -5 2 -1.85676 -0.451272 -0.342641 -1.17801 0.27861 -9.12816 -6 2 -2.51648 -0.764704 -1.74119 1.00433 0.523826 3.94489 -7 1 -0.565581 2.01415 -0.121947 -0.431671 0.816258 1.37224 -8 2 -0.923503 1.54613 0.649943 -0.836345 -0.35076 -8.91816 -9 2 -0.954982 1.61593 -0.9136 -0.398984 -1.29665 6.9827 -10 1 0.971315 -1.16462 1.43403 2.66632 -4.10463 -4.1745 -11 2 0.960388 -1.57587 0.54557 3.80791 8.56867 8.0783 -12 2 1.545 -0.38505 1.37422 -2.3984 -5.62816 -5.66197 -13 1 0.972827 -1.39712 -1.33549 -1.10638 0.442925 0.267527 -14 2 0.0526434 -1.14464 -1.51395 7.06933 2.8298 1.48943 -15 2 1.50554 -0.590868 -1.25662 -6.54392 -2.53639 -0.258333 -16 1 2.00275 1.0584 -0.124848 -7.13185 5.38221 -0.0306111 -17 2 1.13969 1.52381 -0.134074 11.7308 -4.5992 -0.113372 -18 2 2.68869 1.72277 -0.237084 -2.89819 -1.32119 0.257039 -ITEM: TIMESTEP -20 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.51649 -0.18584 1.44395 5.65501 -4.20149 4.07802 -2 2 -0.637196 -0.60535 1.5789 -10.2535 4.51311 -0.350867 -3 2 -2.05196 -0.408647 2.21473 3.52072 0.575858 -3.20585 -4 1 -1.74216 -0.383007 -1.31779 -5.65244 -1.7459 7.46957 -5 2 -1.85838 -0.422286 -0.35262 3.57624 0.698487 -5.03248 -6 2 -2.53778 -0.772973 -1.68856 2.62304 1.05785 -2.46299 -7 1 -0.568621 2.01502 -0.121788 -7.49291 -10.5083 -0.07078 -8 2 -0.953332 1.50031 0.601729 3.90339 5.1027 1.32659 -9 2 -0.948304 1.59097 -0.90055 3.2198 4.86429 -1.5712 -10 1 0.981527 -1.16776 1.43139 8.19382 2.30469 -14.0571 -11 2 0.999682 -1.57682 0.548153 -4.17545 -1.46604 7.90595 -12 2 1.55686 -0.401102 1.29785 -3.41945 -1.35828 5.31582 -13 1 0.971997 -1.39727 -1.33295 -3.50737 11.1512 0.685267 -14 2 0.0679408 -1.0929 -1.49373 1.59713 -5.72522 -0.144088 -15 2 1.47933 -0.582056 -1.22295 2.04209 -4.76253 -0.234646 -16 1 2.00557 1.05551 -0.12468 -4.4992 7.40197 -0.448564 -17 2 1.16008 1.5422 -0.129327 5.1837 -4.83397 0.46283 -18 2 2.69054 1.72007 -0.238059 -0.51465 -3.06849 0.334482 -ITEM: TIMESTEP -30 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.52872 -0.18011 1.45173 -0.933277 -2.21949 5.98424 -2 2 -0.665459 -0.602256 1.60472 0.633036 0.719099 -1.22127 -3 2 -2.07366 -0.404666 2.21589 2.60377 1.4581 -4.42661 -4 1 -1.74225 -0.382648 -1.3226 2.4731 1.57235 -0.799694 -5 2 -1.81423 -0.398932 -0.35676 -3.06045 -1.92828 -1.63228 -6 2 -2.5352 -0.77665 -1.69294 0.0233925 -0.139311 2.03217 -7 1 -0.576286 2.0073 -0.122823 5.68391 5.42307 0.543301 -8 2 -0.95235 1.50691 0.611905 -2.48677 -2.29116 -3.6455 -9 2 -0.915502 1.63076 -0.941481 -3.12923 -3.02599 2.90572 -10 1 0.998541 -1.16996 1.42191 -2.76709 -0.0175982 4.85417 -11 2 0.970261 -1.63876 0.575717 2.4618 4.28015 -0.493825 -12 2 1.54742 -0.386783 1.27666 -1.41861 -3.70889 -3.67396 -13 1 0.969317 -1.3895 -1.32829 2.03562 -5.48364 0.295138 -14 2 0.0583035 -1.11723 -1.49206 1.73159 3.49229 -0.0543931 -15 2 1.50655 -0.600283 -1.19205 -3.9925 1.94925 -1.04523 -16 1 2.00848 1.05446 -0.124132 1.88868 -1.58075 0.754117 -17 2 1.16959 1.53865 -0.11771 0.573913 1.34283 -0.58573 -18 2 2.71517 1.69464 -0.239075 -2.32089 0.157967 0.209615 -ITEM: TIMESTEP -40 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.53726 -0.175397 1.46121 -7.56641 2.45844 -0.518817 -2 2 -0.675238 -0.584022 1.60915 7.85196 -3.99237 1.67217 -3 2 -2.08862 -0.402087 2.21789 3.0617 0.39778 -2.04562 -4 1 -1.73949 -0.379604 -1.32819 -2.36016 -0.787528 -0.0315325 -5 2 -1.83346 -0.428429 -0.37056 1.90026 0.717301 4.17358 -6 2 -2.53017 -0.786871 -1.68316 0.151557 -0.108901 -3.75615 -7 1 -0.576955 2.0043 -0.124416 -0.431513 -1.54355 -1.46354 -8 2 -0.992092 1.48382 0.567817 1.09284 0.418387 6.78235 -9 2 -0.944746 1.62819 -0.925975 0.76441 1.37882 -5.22407 -10 1 1.00941 -1.17308 1.4189 -1.85973 4.64458 1.0889 -11 2 0.973659 -1.6403 0.580693 -1.69219 -4.78957 -3.29195 -12 2 1.53559 -0.396477 1.19908 0.544307 1.46508 3.63166 -13 1 0.969009 -1.38744 -1.3228 -0.275569 1.85307 -0.63583 -14 2 0.0737932 -1.09141 -1.50366 -4.66851 -2.83882 -1.16892 -15 2 1.46633 -0.576681 -1.19175 5.00795 0.70617 0.521536 -16 1 2.01183 1.05054 -0.121932 4.41526 -1.70685 -0.0836272 -17 2 1.19121 1.55327 -0.120038 -7.25224 2.19125 0.154184 -18 2 2.71636 1.68982 -0.237383 1.31607 -0.463304 0.195666 -ITEM: TIMESTEP -50 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.53986 -0.172749 1.46865 -10.3641 5.96951 -4.41562 -2 2 -0.678724 -0.568486 1.60775 14.9207 -7.13278 2.04782 -3 2 -2.07217 -0.405364 2.23045 -0.725799 -0.490948 1.77161 -4 1 -1.74113 -0.378171 -1.32957 5.99712 2.85952 -9.13842 -5 2 -1.82713 -0.447378 -0.375703 -3.89226 -1.3818 7.11516 -6 2 -2.4999 -0.790471 -1.74187 -3.02333 -1.60416 1.77146 -7 1 -0.579496 1.99691 -0.128028 9.72738 10.7655 -0.463519 -8 2 -0.97832 1.50522 0.591572 -4.4866 -5.64841 2.33138 -9 2 -0.951447 1.66071 -0.944057 -3.97244 -4.92262 -1.79974 -10 1 1.01358 -1.17192 1.41393 -6.48605 2.83151 13.495 -11 2 0.960671 -1.668 0.598799 0.887838 -3.18341 -9.75086 -12 2 1.53449 -0.394669 1.19537 2.46945 2.14925 -1.89795 -13 1 0.966791 -1.38037 -1.31946 4.73561 -12.449 -1.17286 -14 2 0.0653014 -1.12956 -1.52441 -4.76491 5.51904 -0.304595 -15 2 1.48076 -0.580834 -1.19775 0.0522693 6.36707 0.249418 -16 1 2.01309 1.04924 -0.119438 7.79557 -11.0594 0.778107 -17 2 1.18753 1.53519 -0.124654 -9.57007 7.63584 -0.456674 -18 2 2.72824 1.67508 -0.226016 0.699647 3.77524 -0.159727 -ITEM: TIMESTEP -60 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.535 -0.173529 1.47468 -12.8115 9.37187 -10.8344 -2 2 -0.673508 -0.564245 1.59147 19.3914 -9.12777 2.73797 -3 2 -2.04099 -0.404174 2.24807 -3.82175 -1.70255 6.71674 -4 1 -1.73996 -0.376347 -1.33351 0.570165 0.280665 -6.43548 -5 2 -1.87928 -0.466718 -0.390362 1.26398 0.876645 10.7815 -6 2 -2.48657 -0.801116 -1.75201 -2.14828 -1.00411 -3.66812 -7 1 -0.576718 1.99595 -0.131852 3.14419 3.30092 -1.47913 -8 2 -0.97416 1.49195 0.577492 -1.32391 -2.58987 8.72867 -9 2 -0.983297 1.63168 -0.91691 -0.334419 -0.770035 -7.07098 -10 1 1.00791 -1.1681 1.41401 -6.20027 1.07549 12.575 -11 2 0.972875 -1.65454 0.593802 -0.476084 -5.46772 -10.3478 -12 2 1.54632 -0.404877 1.20306 3.83119 5.88484 -0.834958 -13 1 0.966385 -1.38017 -1.32091 1.49436 -4.60495 -1.57148 -14 2 0.0722824 -1.10128 -1.51274 -8.16812 -0.531008 -1.13308 -15 2 1.45394 -0.565765 -1.20718 7.01226 4.42564 1.66198 -16 1 2.01308 1.04537 -0.116618 6.94232 -7.944 0.350248 -17 2 1.19126 1.53332 -0.135036 -13.3157 5.74475 0.221956 -18 2 2.70715 1.69348 -0.205764 4.95008 2.7812 -0.398561 -ITEM: TIMESTEP -70 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.52447 -0.177745 1.47754 -14.009 12.5988 -14.9127 -2 2 -0.663619 -0.56979 1.57126 20.9018 -10.2143 3.8986 -3 2 -2.00537 -0.388653 2.26816 -5.41735 -2.91391 10.0958 -4 1 -1.74327 -0.377755 -1.33511 7.69657 4.1782 -9.73798 -5 2 -1.88018 -0.439682 -0.388162 -4.07322 -2.33918 9.17346 -6 2 -2.47021 -0.801057 -1.79014 -4.11028 -2.07522 1.70143 -7 1 -0.576352 1.99233 -0.135801 8.33914 8.33997 -1.40304 -8 2 -0.93279 1.50467 0.607511 -5.01196 -5.05095 3.69276 -9 2 -0.967697 1.61396 -0.924499 -2.96791 -3.60448 -2.11522 -10 1 0.996682 -1.16249 1.41603 -5.52393 -2.7768 9.00886 -11 2 0.982553 -1.62276 0.577115 -1.00274 -4.80219 -7.71302 -12 2 1.55168 -0.404501 1.24312 4.97383 8.09577 -0.603791 -13 1 0.964232 -1.37715 -1.32734 3.83388 -12.0598 -0.0980446 -14 2 0.0575072 -1.10802 -1.48098 -4.628 4.85469 -1.01689 -15 2 1.48931 -0.58697 -1.19891 1.1914 7.02562 -0.119366 -16 1 2.01083 1.04528 -0.114231 6.83173 -12.9986 1.26494 -17 2 1.17034 1.50303 -0.133551 -9.79274 8.34256 -0.476042 -18 2 2.7022 1.69874 -0.182183 2.76884 5.3999 -0.639748 -ITEM: TIMESTEP -80 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.51177 -0.182537 1.47592 -13.1365 10.3139 -11.8951 -2 2 -0.654143 -0.583091 1.57918 18.6975 -8.17701 1.44433 -3 2 -1.97348 -0.365352 2.2852 -6.58467 -1.56222 9.05296 -4 1 -1.74352 -0.377279 -1.33693 -0.505822 0.308788 -3.25308 -5 2 -1.91188 -0.438855 -0.39405 1.95743 0.358158 9.20234 -6 2 -2.48397 -0.807922 -1.76244 -1.16931 -0.70018 -3.86005 -7 1 -0.571778 1.99034 -0.138544 1.3921 0.315501 -1.43854 -8 2 -0.938419 1.50232 0.602337 -1.22478 -1.30903 4.8686 -9 2 -0.959599 1.56918 -0.90914 -0.0288155 0.574454 -3.52808 -10 1 0.985435 -1.15713 1.41811 -6.25848 -6.25702 9.27302 -11 2 0.972167 -1.59168 0.560031 1.69554 -0.201305 -5.06875 -12 2 1.54032 -0.386652 1.30283 4.96928 5.72762 -4.15176 -13 1 0.963614 -1.3793 -1.33436 0.183354 -1.1048 0.823621 -14 2 0.065336 -1.06423 -1.45856 -4.4409 -1.33366 -2.05511 -15 2 1.49256 -0.587857 -1.21654 4.36346 2.23441 0.338535 -16 1 2.00803 1.04345 -0.110717 3.61274 -3.25471 0.639326 -17 2 1.16919 1.51061 -0.133404 -8.46417 2.50048 0.10369 -18 2 2.67828 1.72068 -0.16597 4.94198 1.56662 -0.49597 -ITEM: TIMESTEP -90 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.50159 -0.186388 1.47232 -10.1666 8.56134 -9.06842 -2 2 -0.637201 -0.589948 1.58141 9.00709 -5.13609 3.43504 -3 2 -1.97805 -0.327506 2.28752 -1.76215 -2.05269 5.01359 -4 1 -1.7485 -0.377921 -1.33249 5.81313 3.27044 -5.4853 -5 2 -1.87141 -0.433051 -0.37781 -3.50795 -2.5324 4.09176 -6 2 -2.48522 -0.804273 -1.77362 -2.18894 -1.0456 2.79096 -7 1 -0.568425 1.98378 -0.140489 1.33268 1.60885 -0.760228 -8 2 -0.945484 1.51375 0.61188 -1.03442 -1.79649 -0.570033 -9 2 -0.936389 1.56212 -0.924193 -1.07342 -0.200973 1.02154 -10 1 0.975854 -1.15481 1.42351 1.86741 -2.52595 -4.21318 -11 2 0.98193 -1.53917 0.537259 -2.6087 -4.02599 1.03016 -12 2 1.52752 -0.379325 1.30866 2.98513 5.11632 2.51897 -13 1 0.962056 -1.37771 -1.33914 1.58342 -3.36145 0.893222 -14 2 0.0608833 -1.06855 -1.4877 0.530861 1.7595 -0.414339 -15 2 1.52774 -0.603203 -1.25083 -2.15602 1.98356 -0.537593 -16 1 2.00483 1.04652 -0.10624 2.44039 -5.05754 0.604689 -17 2 1.15126 1.49959 -0.126569 -0.261743 3.34267 -0.115684 -18 2 2.69252 1.71134 -0.15978 -0.800158 2.09248 -0.235157 -ITEM: TIMESTEP -100 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.49915 -0.184572 1.46491 -1.64286 -0.923423 4.11541 -2 2 -0.634606 -0.601439 1.61658 -0.503947 1.48506 -2.91046 -3 2 -1.9835 -0.312527 2.28463 -1.23961 0.673264 -1.96712 -4 1 -1.74898 -0.375873 -1.32741 -4.05983 -3.09974 1.92324 -5 2 -1.86884 -0.471305 -0.372769 3.24632 2.33491 1.76011 -6 2 -2.50916 -0.806172 -1.72327 1.14638 0.924599 -3.12385 -7 1 -0.564884 1.97778 -0.142101 -4.14881 -3.0738 -0.168062 -8 2 -0.958996 1.4911 0.595477 2.25574 1.20147 -1.85844 -9 2 -0.937749 1.56372 -0.930264 1.31445 2.00952 1.76263 -10 1 0.975211 -1.15256 1.42364 -0.947501 -4.6035 2.62584 -11 2 0.950951 -1.55837 0.541757 3.10583 4.89391 1.85772 -12 2 1.52342 -0.363228 1.34082 0.672959 -1.69053 -5.30235 -13 1 0.962361 -1.37851 -1.34242 -1.40487 6.54708 -1.50719 -14 2 0.0703818 -1.05861 -1.53269 1.44041 -3.14031 1.12109 -15 2 1.51335 -0.586474 -1.29057 -0.612624 -3.69916 1.63647 -16 1 2.00445 1.04687 -0.100669 -1.02523 8.04786 -0.336895 -17 2 1.16075 1.52969 -0.119062 2.24423 -4.67525 0.190963 -18 2 2.68635 1.72058 -0.160395 0.158945 -3.21195 0.180894 diff --git a/examples/amoeba/dump.water_hexamer.hippo.1.test b/examples/amoeba/dump.water_hexamer.hippo.1.test deleted file mode 100644 index a808eb88d8..0000000000 --- a/examples/amoeba/dump.water_hexamer.hippo.1.test +++ /dev/null @@ -1,297 +0,0 @@ -ITEM: TIMESTEP -0 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.50217 -0.191359 1.43493 19.9357 -10.2022 6.39617 -2 2 -0.601054 -0.596972 1.55372 -26.7746 11.7551 -3.2269 -3 2 -2.0067 -0.422327 2.21985 2.27453 0.843475 -3.26617 -4 1 -1.74457 -0.382348 -1.30914 -7.45906 -3.26138 10.4208 -5 2 -1.88894 -0.479653 -0.347624 4.39096 1.86538 -10.993 -6 2 -2.51683 -0.766765 -1.73377 3.97889 2.0308 0.238005 -7 1 -0.560409 2.01783 -0.121984 -15.0354 -12.151 1.41176 -8 2 -0.94772 1.53357 0.625228 7.62359 5.98784 -1.89388 -9 2 -0.989831 1.59274 -0.877419 6.55934 4.96076 0.527359 -10 1 0.964803 -1.16576 1.43999 15.4285 1.35636 -21.3173 -11 2 0.979557 -1.52204 0.527833 -6.23862 0.631634 14.3987 -12 2 1.54222 -0.393692 1.34437 -5.98579 -2.68738 6.2337 -13 1 0.974705 -1.4015 -1.33597 -5.70279 13.9492 -3.53962 -14 2 0.065161 -1.11895 -1.52289 5.16041 -6.4649 2.71211 -15 2 1.47071 -0.570933 -1.27771 0.726496 -6.9774 1.88925 -16 1 2.00228 1.05782 -0.124502 -11.1831 12.6873 -1.41281 -17 2 1.14164 1.53227 -0.140121 14.1175 -10.0366 0.774885 -18 2 2.67472 1.73534 -0.237995 -1.81661 -4.28693 0.646829 -ITEM: TIMESTEP -10 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.50519 -0.189085 1.43489 16.1346 -9.03082 7.39643 -2 2 -0.613325 -0.596599 1.55623 -19.7 9.16793 -3.06694 -3 2 -2.00781 -0.423676 2.21968 1.11569 1.33017 -3.51515 -4 1 -1.74545 -0.38218 -1.30921 -0.873137 -0.924011 5.81502 -5 2 -1.86379 -0.472478 -0.34573 -0.592473 0.521176 -9.80595 -6 2 -2.51308 -0.764814 -1.7423 1.95383 0.883641 3.34899 -7 1 -0.566746 2.01551 -0.121884 -0.752908 0.880358 1.51675 -8 2 -0.90288 1.53899 0.653422 -0.370038 -0.282546 -8.72932 -9 2 -0.948386 1.59852 -0.906373 -0.161598 -1.83495 7.27882 -10 1 0.972994 -1.16632 1.4367 2.1365 -3.63541 -4.30666 -11 2 0.921471 -1.54563 0.536978 3.92948 8.96444 9.02535 -12 2 1.51571 -0.366599 1.37318 -3.05971 -5.7155 -5.67471 -13 1 0.973913 -1.39785 -1.33834 -1.44621 0.344209 -0.720777 -14 2 0.0503221 -1.15099 -1.50181 7.085 2.52089 1.36272 -15 2 1.49605 -0.587274 -1.24124 -6.30793 -2.23617 0.0453877 -16 1 2.00301 1.05777 -0.1249 -8.37521 5.68727 -0.0787125 -17 2 1.13805 1.51682 -0.135757 12.8554 -4.94557 -0.27859 -18 2 2.68412 1.72611 -0.2366 -3.57128 -1.69512 0.387339 -ITEM: TIMESTEP -20 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.51053 -0.184679 1.43662 2.59225 -2.34383 2.4228 -2 2 -0.638864 -0.59446 1.56144 -3.81751 1.45077 0.169365 -3 2 -2.02892 -0.415768 2.21112 1.3915 0.960529 -2.2268 -4 1 -1.7422 -0.380161 -1.31156 -2.81538 -1.6524 5.61723 -5 2 -1.87085 -0.467579 -0.355121 2.06181 1.26201 -3.01668 -6 2 -2.51909 -0.769609 -1.71571 1.56589 0.868196 -2.04346 -7 1 -0.571857 2.01726 -0.121524 -4.42229 -10.7497 0.101549 -8 2 -0.894989 1.49275 0.621756 1.9428 5.13739 2.3456 -9 2 -0.928333 1.53949 -0.878364 1.74391 4.55343 -2.63937 -10 1 0.983665 -1.17004 1.43811 2.15858 5.32924 -12.0192 -11 2 0.916986 -1.51176 0.532863 -0.801958 -4.34579 6.00669 -12 2 1.48632 -0.356933 1.30471 -0.115562 -1.35756 5.38685 -13 1 0.974155 -1.39809 -1.34091 -3.6872 9.81415 2.33229 -14 2 0.0608639 -1.11508 -1.47548 0.727822 -4.45373 -1.43277 -15 2 1.45945 -0.57705 -1.18377 2.74992 -3.83937 -1.32423 -16 1 2.0041 1.05318 -0.12468 -4.82863 5.07797 -0.287867 -17 2 1.15863 1.52924 -0.140109 2.7798 -3.05413 0.358119 -18 2 2.67895 1.72504 -0.234758 0.77424 -2.65718 0.249897 -ITEM: TIMESTEP -30 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.5148 -0.180382 1.43888 -14.0787 7.25927 -2.0787 -2 2 -0.670243 -0.596746 1.58256 15.1847 -7.27642 2.26385 -3 2 -2.0578 -0.394757 2.19803 0.335566 -0.184039 0.277588 -4 1 -1.73953 -0.378972 -1.31065 5.17639 2.63373 -5.13987 -5 2 -1.85923 -0.443728 -0.358889 -2.57415 -1.51426 3.86387 -6 2 -2.50599 -0.762479 -1.73443 -2.25678 -0.997735 0.886673 -7 1 -0.57869 2.00716 -0.122116 7.46708 7.5609 -0.932554 -8 2 -0.891326 1.5227 0.646189 -3.77932 -4.24552 -0.379656 -9 2 -0.906489 1.54888 -0.899539 -3.74504 -3.89196 0.775918 -10 1 0.993915 -1.16716 1.4314 -4.03671 -0.827424 10.5116 -11 2 0.932938 -1.58361 0.567361 1.80347 1.36047 -5.88474 -12 2 1.49414 -0.355801 1.3027 1.34198 0.116597 -4.03649 -13 1 0.970608 -1.38983 -1.33905 4.21477 -7.05635 0.421831 -14 2 0.0575618 -1.13428 -1.49637 -1.45416 4.35852 0.0411765 -15 2 1.48422 -0.594211 -1.16216 -2.77696 3.0816 -1.11496 -16 1 2.00096 1.05017 -0.124007 4.94447 -7.97826 1.06585 -17 2 1.17138 1.53183 -0.140668 -5.63771 5.40691 -0.274313 -18 2 2.7082 1.68479 -0.23083 -0.128954 2.19398 -0.267092 -ITEM: TIMESTEP -40 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.5186 -0.17605 1.44225 -24.1552 14.2056 -8.76949 -2 2 -0.687962 -0.594151 1.59127 27.1026 -13.0552 4.45143 -3 2 -2.07116 -0.378379 2.19317 -1.29427 -1.5252 3.96365 -4 1 -1.73305 -0.375414 -1.31137 2.16372 2.0419 -7.75161 -5 2 -1.87951 -0.450834 -0.370226 0.624847 -0.775772 11.2387 -6 2 -2.50254 -0.754697 -1.72909 -2.50645 -1.07375 -3.54713 -7 1 -0.578876 1.99941 -0.124067 2.19183 2.88771 -2.2033 -8 2 -0.936478 1.52242 0.623048 -0.431918 -2.06784 8.93732 -9 2 -0.943689 1.52907 -0.872983 -0.503357 -0.655131 -7.36871 -10 1 1.00066 -1.16525 1.43041 -2.12968 1.37125 11.5778 -11 2 0.974279 -1.60078 0.583019 -3.02955 -6.45349 -11.2722 -12 2 1.51087 -0.375422 1.25067 2.49642 6.22795 1.24643 -13 1 0.96952 -1.38626 -1.33641 3.1199 -1.09706 -1.06644 -14 2 0.0736705 -1.0998 -1.50988 -8.20047 -1.85824 -0.95018 -15 2 1.45433 -0.57243 -1.18601 5.63783 2.37426 1.20997 -16 1 1.9962 1.04317 -0.122075 10.6231 -9.89832 0.540427 -17 2 1.19663 1.55837 -0.138658 -15.3708 7.22601 0.146924 -18 2 2.71508 1.6609 -0.228386 3.66149 2.12531 -0.383549 -ITEM: TIMESTEP -50 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.52326 -0.171807 1.44556 -19.3809 13.2253 -10.6114 -2 2 -0.679923 -0.574818 1.57581 25.4624 -12.0419 4.4477 -3 2 -2.05017 -0.382025 2.20867 -3.53537 -2.33472 6.62258 -4 1 -1.72947 -0.37135 -1.31158 7.45117 4.03521 -12.7525 -5 2 -1.85272 -0.46757 -0.370426 -4.08312 -1.86842 12.0545 -6 2 -2.4914 -0.737252 -1.75485 -4.03109 -2.01148 0.403261 -7 1 -0.581812 1.98886 -0.127591 8.73336 12.0451 -2.23223 -8 2 -0.927295 1.54015 0.641551 -4.26906 -6.45964 5.24049 -9 2 -0.953055 1.5416 -0.887204 -3.28906 -5.2042 -3.24355 -10 1 1.00866 -1.16393 1.43094 -5.76797 0.688141 16.3003 -11 2 0.941718 -1.59751 0.586621 -0.69625 -5.79697 -13.9615 -12 2 1.5005 -0.365594 1.24465 4.16474 6.46538 -1.29083 -13 1 0.968591 -1.37822 -1.33754 5.88173 -13.6635 -0.995409 -14 2 0.058765 -1.13465 -1.50083 -6.65826 5.43105 -0.991523 -15 2 1.47128 -0.574689 -1.20309 0.663977 7.53437 1.14922 -16 1 1.99172 1.03702 -0.120004 11.7209 -15.9347 1.25003 -17 2 1.18616 1.54124 -0.127765 -14.4197 10.6401 -0.950727 -18 2 2.7224 1.64022 -0.223578 2.05256 5.25094 -0.438473 -ITEM: TIMESTEP -60 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.52514 -0.169424 1.44931 -5.6044 5.71407 -7.65735 -2 2 -0.654856 -0.548823 1.55951 12.8877 -6.19997 1.70589 -3 2 -2.01089 -0.399975 2.23335 -4.71544 -1.47688 6.26364 -4 1 -1.72371 -0.366036 -1.3145 0.154709 0.0103655 -5.79078 -5 2 -1.86537 -0.486382 -0.375504 0.204748 0.738589 9.60402 -6 2 -2.49691 -0.728317 -1.74343 -1.12209 -0.453095 -3.27306 -7 1 -0.582396 1.98478 -0.131637 3.0799 3.10149 -1.36944 -8 2 -0.917703 1.51358 0.63199 -1.67497 -1.52591 5.69623 -9 2 -0.95935 1.51373 -0.876424 -0.704912 -1.0485 -4.50039 -10 1 1.01141 -1.16147 1.43332 -7.40944 0.284109 12.5023 -11 2 0.911102 -1.56686 0.573359 1.73368 -3.47737 -10.1102 -12 2 1.49548 -0.352196 1.26684 4.34342 4.22027 -2.29553 -13 1 0.969684 -1.37685 -1.34222 -0.51092 -4.11589 -0.224969 -14 2 0.0587056 -1.1173 -1.48363 -6.15339 -0.904158 -2.27293 -15 2 1.44029 -0.555019 -1.20354 6.44357 4.32801 1.75924 -16 1 1.98854 1.02727 -0.117121 5.38674 -4.81439 0.472007 -17 2 1.17286 1.52668 -0.137432 -10.3716 4.01885 -0.196355 -18 2 2.69 1.66639 -0.213741 4.03261 1.60042 -0.312306 -ITEM: TIMESTEP -70 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.52005 -0.170765 1.45435 7.42813 -0.682132 -3.31568 -2 2 -0.627795 -0.545781 1.54703 -4.484 0.351316 0.767932 -3 2 -1.9938 -0.405389 2.24937 -1.65789 -0.838399 2.61041 -4 1 -1.72181 -0.363627 -1.31513 2.63115 1.26887 -2.8752 -5 2 -1.86247 -0.45623 -0.365408 -2.65258 -1.1368 1.02525 -6 2 -2.4895 -0.712321 -1.77001 -0.898587 -0.369019 2.21573 -7 1 -0.583063 1.97962 -0.135858 1.67055 0.570004 -0.383383 -8 2 -0.908051 1.51128 0.64094 -1.16679 -0.0785678 -0.520586 -9 2 -0.943124 1.49995 -0.888932 -0.754685 -0.199723 0.596245 -10 1 1.00431 -1.15529 1.43647 -0.676345 0.911353 -2.95012 -11 2 0.95109 -1.53365 0.551095 -1.85378 -3.64627 0.0738184 -12 2 1.52689 -0.36229 1.29214 1.34973 2.90443 2.73267 -13 1 0.96764 -1.3732 -1.34735 0.830518 -7.82237 0.0710001 -14 2 0.049796 -1.13062 -1.50565 0.0671147 3.17314 0.120857 -15 2 1.46341 -0.566541 -1.18509 -0.178936 4.65822 -0.507667 -16 1 1.98438 1.02188 -0.114233 -0.881295 -2.57322 0.275288 -17 2 1.13419 1.48172 -0.149659 1.87909 1.86036 0.463365 -18 2 2.6735 1.67987 -0.202074 -0.651386 1.64881 -0.399918 -ITEM: TIMESTEP -80 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.50978 -0.173017 1.45833 15.0482 -9.57345 5.77126 -2 2 -0.617503 -0.581602 1.56045 -17.3455 8.85736 -2.90765 -3 2 -1.99215 -0.403845 2.25671 0.833211 1.42908 -3.53001 -4 1 -1.71857 -0.360372 -1.31644 -7.32338 -2.11362 6.45601 -5 2 -1.89982 -0.440583 -0.365391 4.39327 0.727605 -4.87947 -6 2 -2.49827 -0.701359 -1.75982 2.51785 1.20426 -1.18541 -7 1 -0.581108 1.97455 -0.140769 -3.87733 -3.80002 1.10694 -8 2 -0.928789 1.51932 0.641149 2.19408 2.20718 -5.07369 -9 2 -0.943839 1.48954 -0.89443 1.32563 2.05291 3.72773 -10 1 0.995847 -1.14613 1.43537 0.755936 -5.6909 -0.46639 -11 2 0.966841 -1.55186 0.550806 1.56938 7.42451 5.54707 -12 2 1.55511 -0.362342 1.35836 -2.79165 -2.9995 -5.36768 -13 1 0.967816 -1.37465 -1.35163 -3.29308 4.65803 -0.872226 -14 2 0.0602027 -1.09254 -1.5264 2.56737 -3.64929 1.27094 -15 2 1.45854 -0.559392 -1.19328 1.84002 -1.84978 0.0538636 -16 1 1.98052 1.0158 -0.111184 -7.14388 11.5516 -0.816233 -17 2 1.12003 1.47724 -0.140032 8.70268 -6.85942 1.26876 -18 2 2.64114 1.706 -0.201685 0.0272078 -3.57662 -0.103793 -ITEM: TIMESTEP -90 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.50003 -0.175917 1.46165 15.3898 -11.884 8.8546 -2 2 -0.608584 -0.600731 1.57129 -23.7815 11.9323 -1.75151 -3 2 -2.00991 -0.394435 2.25305 5.57059 1.55514 -7.64598 -4 1 -1.72137 -0.357368 -1.31563 -1.93902 -0.246344 7.85181 -5 2 -1.87234 -0.43987 -0.353482 -0.118832 -0.772284 -11.4834 -6 2 -2.49861 -0.682857 -1.77755 1.48512 0.513779 4.12935 -7 1 -0.579472 1.97061 -0.145894 -8.85759 -8.26094 2.77276 -8 2 -0.945449 1.52054 0.635243 4.66427 4.57627 -6.94972 -9 2 -0.952686 1.48464 -0.897126 3.60343 4.09955 4.74753 -10 1 0.988258 -1.14419 1.44127 11.1074 1.88534 -20.9154 -11 2 0.971991 -1.50516 0.531218 -4.29535 0.162687 14.3489 -12 2 1.5415 -0.356231 1.32305 -5.76468 -4.25266 5.91571 -13 1 0.969416 -1.37359 -1.35605 -1.23717 3.53556 0.174563 -14 2 0.053578 -1.1004 -1.52114 7.10928 -0.236326 1.96556 -15 2 1.49219 -0.569722 -1.21186 -5.0738 -3.24139 -1.5161 -16 1 1.97824 1.01566 -0.108279 -8.95647 8.69277 0.191958 -17 2 1.10027 1.45664 -0.104435 15.9218 -5.21388 -1.22481 -18 2 2.64464 1.70165 -0.21558 -4.82724 -2.84557 0.534172 -ITEM: TIMESTEP -100 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.4951 -0.17739 1.46185 11.6291 -12.0775 13.5087 -2 2 -0.608426 -0.588808 1.60852 -19.0988 9.4339 -4.86631 -3 2 -2.01619 -0.397996 2.24676 4.77562 3.06476 -9.1756 -4 1 -1.72287 -0.352149 -1.31567 -8.10325 -4.84048 12.8242 -5 2 -1.86729 -0.479262 -0.356777 4.49726 3.58866 -11.0242 -6 2 -2.51926 -0.676876 -1.74282 3.42966 1.20159 -1.20299 -7 1 -0.581355 1.96754 -0.149521 -5.24612 -4.66563 2.71982 -8 2 -0.935394 1.51644 0.636953 2.89489 2.96603 -9.31226 -9 2 -0.942573 1.488 -0.91114 1.96254 2.34604 7.29302 -10 1 0.988651 -1.14425 1.44045 0.840008 -1.36718 -7.83612 -11 2 0.899639 -1.53136 0.543246 5.64911 9.69241 11.7913 -12 2 1.49178 -0.318235 1.33897 -3.7582 -9.86315 -4.79205 -13 1 0.974233 -1.37573 -1.35945 -3.77942 11.331 0.435153 -14 2 0.0583408 -1.08758 -1.49668 6.15796 -3.89994 -0.197074 -15 2 1.48764 -0.558876 -1.24121 -3.14566 -8.24544 0.525665 -16 1 1.97883 1.01496 -0.10404 -9.03485 15.6667 -0.929518 -17 2 1.11471 1.47883 -0.106249 11.9101 -8.77208 -0.858699 -18 2 2.63671 1.70526 -0.232286 -1.57994 -5.55972 1.09694 diff --git a/examples/amoeba/dump.water_hexamer.hippo.4.test b/examples/amoeba/dump.water_hexamer.hippo.4.test deleted file mode 100644 index a808eb88d8..0000000000 --- a/examples/amoeba/dump.water_hexamer.hippo.4.test +++ /dev/null @@ -1,297 +0,0 @@ -ITEM: TIMESTEP -0 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.50217 -0.191359 1.43493 19.9357 -10.2022 6.39617 -2 2 -0.601054 -0.596972 1.55372 -26.7746 11.7551 -3.2269 -3 2 -2.0067 -0.422327 2.21985 2.27453 0.843475 -3.26617 -4 1 -1.74457 -0.382348 -1.30914 -7.45906 -3.26138 10.4208 -5 2 -1.88894 -0.479653 -0.347624 4.39096 1.86538 -10.993 -6 2 -2.51683 -0.766765 -1.73377 3.97889 2.0308 0.238005 -7 1 -0.560409 2.01783 -0.121984 -15.0354 -12.151 1.41176 -8 2 -0.94772 1.53357 0.625228 7.62359 5.98784 -1.89388 -9 2 -0.989831 1.59274 -0.877419 6.55934 4.96076 0.527359 -10 1 0.964803 -1.16576 1.43999 15.4285 1.35636 -21.3173 -11 2 0.979557 -1.52204 0.527833 -6.23862 0.631634 14.3987 -12 2 1.54222 -0.393692 1.34437 -5.98579 -2.68738 6.2337 -13 1 0.974705 -1.4015 -1.33597 -5.70279 13.9492 -3.53962 -14 2 0.065161 -1.11895 -1.52289 5.16041 -6.4649 2.71211 -15 2 1.47071 -0.570933 -1.27771 0.726496 -6.9774 1.88925 -16 1 2.00228 1.05782 -0.124502 -11.1831 12.6873 -1.41281 -17 2 1.14164 1.53227 -0.140121 14.1175 -10.0366 0.774885 -18 2 2.67472 1.73534 -0.237995 -1.81661 -4.28693 0.646829 -ITEM: TIMESTEP -10 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.50519 -0.189085 1.43489 16.1346 -9.03082 7.39643 -2 2 -0.613325 -0.596599 1.55623 -19.7 9.16793 -3.06694 -3 2 -2.00781 -0.423676 2.21968 1.11569 1.33017 -3.51515 -4 1 -1.74545 -0.38218 -1.30921 -0.873137 -0.924011 5.81502 -5 2 -1.86379 -0.472478 -0.34573 -0.592473 0.521176 -9.80595 -6 2 -2.51308 -0.764814 -1.7423 1.95383 0.883641 3.34899 -7 1 -0.566746 2.01551 -0.121884 -0.752908 0.880358 1.51675 -8 2 -0.90288 1.53899 0.653422 -0.370038 -0.282546 -8.72932 -9 2 -0.948386 1.59852 -0.906373 -0.161598 -1.83495 7.27882 -10 1 0.972994 -1.16632 1.4367 2.1365 -3.63541 -4.30666 -11 2 0.921471 -1.54563 0.536978 3.92948 8.96444 9.02535 -12 2 1.51571 -0.366599 1.37318 -3.05971 -5.7155 -5.67471 -13 1 0.973913 -1.39785 -1.33834 -1.44621 0.344209 -0.720777 -14 2 0.0503221 -1.15099 -1.50181 7.085 2.52089 1.36272 -15 2 1.49605 -0.587274 -1.24124 -6.30793 -2.23617 0.0453877 -16 1 2.00301 1.05777 -0.1249 -8.37521 5.68727 -0.0787125 -17 2 1.13805 1.51682 -0.135757 12.8554 -4.94557 -0.27859 -18 2 2.68412 1.72611 -0.2366 -3.57128 -1.69512 0.387339 -ITEM: TIMESTEP -20 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.51053 -0.184679 1.43662 2.59225 -2.34383 2.4228 -2 2 -0.638864 -0.59446 1.56144 -3.81751 1.45077 0.169365 -3 2 -2.02892 -0.415768 2.21112 1.3915 0.960529 -2.2268 -4 1 -1.7422 -0.380161 -1.31156 -2.81538 -1.6524 5.61723 -5 2 -1.87085 -0.467579 -0.355121 2.06181 1.26201 -3.01668 -6 2 -2.51909 -0.769609 -1.71571 1.56589 0.868196 -2.04346 -7 1 -0.571857 2.01726 -0.121524 -4.42229 -10.7497 0.101549 -8 2 -0.894989 1.49275 0.621756 1.9428 5.13739 2.3456 -9 2 -0.928333 1.53949 -0.878364 1.74391 4.55343 -2.63937 -10 1 0.983665 -1.17004 1.43811 2.15858 5.32924 -12.0192 -11 2 0.916986 -1.51176 0.532863 -0.801958 -4.34579 6.00669 -12 2 1.48632 -0.356933 1.30471 -0.115562 -1.35756 5.38685 -13 1 0.974155 -1.39809 -1.34091 -3.6872 9.81415 2.33229 -14 2 0.0608639 -1.11508 -1.47548 0.727822 -4.45373 -1.43277 -15 2 1.45945 -0.57705 -1.18377 2.74992 -3.83937 -1.32423 -16 1 2.0041 1.05318 -0.12468 -4.82863 5.07797 -0.287867 -17 2 1.15863 1.52924 -0.140109 2.7798 -3.05413 0.358119 -18 2 2.67895 1.72504 -0.234758 0.77424 -2.65718 0.249897 -ITEM: TIMESTEP -30 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.5148 -0.180382 1.43888 -14.0787 7.25927 -2.0787 -2 2 -0.670243 -0.596746 1.58256 15.1847 -7.27642 2.26385 -3 2 -2.0578 -0.394757 2.19803 0.335566 -0.184039 0.277588 -4 1 -1.73953 -0.378972 -1.31065 5.17639 2.63373 -5.13987 -5 2 -1.85923 -0.443728 -0.358889 -2.57415 -1.51426 3.86387 -6 2 -2.50599 -0.762479 -1.73443 -2.25678 -0.997735 0.886673 -7 1 -0.57869 2.00716 -0.122116 7.46708 7.5609 -0.932554 -8 2 -0.891326 1.5227 0.646189 -3.77932 -4.24552 -0.379656 -9 2 -0.906489 1.54888 -0.899539 -3.74504 -3.89196 0.775918 -10 1 0.993915 -1.16716 1.4314 -4.03671 -0.827424 10.5116 -11 2 0.932938 -1.58361 0.567361 1.80347 1.36047 -5.88474 -12 2 1.49414 -0.355801 1.3027 1.34198 0.116597 -4.03649 -13 1 0.970608 -1.38983 -1.33905 4.21477 -7.05635 0.421831 -14 2 0.0575618 -1.13428 -1.49637 -1.45416 4.35852 0.0411765 -15 2 1.48422 -0.594211 -1.16216 -2.77696 3.0816 -1.11496 -16 1 2.00096 1.05017 -0.124007 4.94447 -7.97826 1.06585 -17 2 1.17138 1.53183 -0.140668 -5.63771 5.40691 -0.274313 -18 2 2.7082 1.68479 -0.23083 -0.128954 2.19398 -0.267092 -ITEM: TIMESTEP -40 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.5186 -0.17605 1.44225 -24.1552 14.2056 -8.76949 -2 2 -0.687962 -0.594151 1.59127 27.1026 -13.0552 4.45143 -3 2 -2.07116 -0.378379 2.19317 -1.29427 -1.5252 3.96365 -4 1 -1.73305 -0.375414 -1.31137 2.16372 2.0419 -7.75161 -5 2 -1.87951 -0.450834 -0.370226 0.624847 -0.775772 11.2387 -6 2 -2.50254 -0.754697 -1.72909 -2.50645 -1.07375 -3.54713 -7 1 -0.578876 1.99941 -0.124067 2.19183 2.88771 -2.2033 -8 2 -0.936478 1.52242 0.623048 -0.431918 -2.06784 8.93732 -9 2 -0.943689 1.52907 -0.872983 -0.503357 -0.655131 -7.36871 -10 1 1.00066 -1.16525 1.43041 -2.12968 1.37125 11.5778 -11 2 0.974279 -1.60078 0.583019 -3.02955 -6.45349 -11.2722 -12 2 1.51087 -0.375422 1.25067 2.49642 6.22795 1.24643 -13 1 0.96952 -1.38626 -1.33641 3.1199 -1.09706 -1.06644 -14 2 0.0736705 -1.0998 -1.50988 -8.20047 -1.85824 -0.95018 -15 2 1.45433 -0.57243 -1.18601 5.63783 2.37426 1.20997 -16 1 1.9962 1.04317 -0.122075 10.6231 -9.89832 0.540427 -17 2 1.19663 1.55837 -0.138658 -15.3708 7.22601 0.146924 -18 2 2.71508 1.6609 -0.228386 3.66149 2.12531 -0.383549 -ITEM: TIMESTEP -50 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.52326 -0.171807 1.44556 -19.3809 13.2253 -10.6114 -2 2 -0.679923 -0.574818 1.57581 25.4624 -12.0419 4.4477 -3 2 -2.05017 -0.382025 2.20867 -3.53537 -2.33472 6.62258 -4 1 -1.72947 -0.37135 -1.31158 7.45117 4.03521 -12.7525 -5 2 -1.85272 -0.46757 -0.370426 -4.08312 -1.86842 12.0545 -6 2 -2.4914 -0.737252 -1.75485 -4.03109 -2.01148 0.403261 -7 1 -0.581812 1.98886 -0.127591 8.73336 12.0451 -2.23223 -8 2 -0.927295 1.54015 0.641551 -4.26906 -6.45964 5.24049 -9 2 -0.953055 1.5416 -0.887204 -3.28906 -5.2042 -3.24355 -10 1 1.00866 -1.16393 1.43094 -5.76797 0.688141 16.3003 -11 2 0.941718 -1.59751 0.586621 -0.69625 -5.79697 -13.9615 -12 2 1.5005 -0.365594 1.24465 4.16474 6.46538 -1.29083 -13 1 0.968591 -1.37822 -1.33754 5.88173 -13.6635 -0.995409 -14 2 0.058765 -1.13465 -1.50083 -6.65826 5.43105 -0.991523 -15 2 1.47128 -0.574689 -1.20309 0.663977 7.53437 1.14922 -16 1 1.99172 1.03702 -0.120004 11.7209 -15.9347 1.25003 -17 2 1.18616 1.54124 -0.127765 -14.4197 10.6401 -0.950727 -18 2 2.7224 1.64022 -0.223578 2.05256 5.25094 -0.438473 -ITEM: TIMESTEP -60 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.52514 -0.169424 1.44931 -5.6044 5.71407 -7.65735 -2 2 -0.654856 -0.548823 1.55951 12.8877 -6.19997 1.70589 -3 2 -2.01089 -0.399975 2.23335 -4.71544 -1.47688 6.26364 -4 1 -1.72371 -0.366036 -1.3145 0.154709 0.0103655 -5.79078 -5 2 -1.86537 -0.486382 -0.375504 0.204748 0.738589 9.60402 -6 2 -2.49691 -0.728317 -1.74343 -1.12209 -0.453095 -3.27306 -7 1 -0.582396 1.98478 -0.131637 3.0799 3.10149 -1.36944 -8 2 -0.917703 1.51358 0.63199 -1.67497 -1.52591 5.69623 -9 2 -0.95935 1.51373 -0.876424 -0.704912 -1.0485 -4.50039 -10 1 1.01141 -1.16147 1.43332 -7.40944 0.284109 12.5023 -11 2 0.911102 -1.56686 0.573359 1.73368 -3.47737 -10.1102 -12 2 1.49548 -0.352196 1.26684 4.34342 4.22027 -2.29553 -13 1 0.969684 -1.37685 -1.34222 -0.51092 -4.11589 -0.224969 -14 2 0.0587056 -1.1173 -1.48363 -6.15339 -0.904158 -2.27293 -15 2 1.44029 -0.555019 -1.20354 6.44357 4.32801 1.75924 -16 1 1.98854 1.02727 -0.117121 5.38674 -4.81439 0.472007 -17 2 1.17286 1.52668 -0.137432 -10.3716 4.01885 -0.196355 -18 2 2.69 1.66639 -0.213741 4.03261 1.60042 -0.312306 -ITEM: TIMESTEP -70 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.52005 -0.170765 1.45435 7.42813 -0.682132 -3.31568 -2 2 -0.627795 -0.545781 1.54703 -4.484 0.351316 0.767932 -3 2 -1.9938 -0.405389 2.24937 -1.65789 -0.838399 2.61041 -4 1 -1.72181 -0.363627 -1.31513 2.63115 1.26887 -2.8752 -5 2 -1.86247 -0.45623 -0.365408 -2.65258 -1.1368 1.02525 -6 2 -2.4895 -0.712321 -1.77001 -0.898587 -0.369019 2.21573 -7 1 -0.583063 1.97962 -0.135858 1.67055 0.570004 -0.383383 -8 2 -0.908051 1.51128 0.64094 -1.16679 -0.0785678 -0.520586 -9 2 -0.943124 1.49995 -0.888932 -0.754685 -0.199723 0.596245 -10 1 1.00431 -1.15529 1.43647 -0.676345 0.911353 -2.95012 -11 2 0.95109 -1.53365 0.551095 -1.85378 -3.64627 0.0738184 -12 2 1.52689 -0.36229 1.29214 1.34973 2.90443 2.73267 -13 1 0.96764 -1.3732 -1.34735 0.830518 -7.82237 0.0710001 -14 2 0.049796 -1.13062 -1.50565 0.0671147 3.17314 0.120857 -15 2 1.46341 -0.566541 -1.18509 -0.178936 4.65822 -0.507667 -16 1 1.98438 1.02188 -0.114233 -0.881295 -2.57322 0.275288 -17 2 1.13419 1.48172 -0.149659 1.87909 1.86036 0.463365 -18 2 2.6735 1.67987 -0.202074 -0.651386 1.64881 -0.399918 -ITEM: TIMESTEP -80 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.50978 -0.173017 1.45833 15.0482 -9.57345 5.77126 -2 2 -0.617503 -0.581602 1.56045 -17.3455 8.85736 -2.90765 -3 2 -1.99215 -0.403845 2.25671 0.833211 1.42908 -3.53001 -4 1 -1.71857 -0.360372 -1.31644 -7.32338 -2.11362 6.45601 -5 2 -1.89982 -0.440583 -0.365391 4.39327 0.727605 -4.87947 -6 2 -2.49827 -0.701359 -1.75982 2.51785 1.20426 -1.18541 -7 1 -0.581108 1.97455 -0.140769 -3.87733 -3.80002 1.10694 -8 2 -0.928789 1.51932 0.641149 2.19408 2.20718 -5.07369 -9 2 -0.943839 1.48954 -0.89443 1.32563 2.05291 3.72773 -10 1 0.995847 -1.14613 1.43537 0.755936 -5.6909 -0.46639 -11 2 0.966841 -1.55186 0.550806 1.56938 7.42451 5.54707 -12 2 1.55511 -0.362342 1.35836 -2.79165 -2.9995 -5.36768 -13 1 0.967816 -1.37465 -1.35163 -3.29308 4.65803 -0.872226 -14 2 0.0602027 -1.09254 -1.5264 2.56737 -3.64929 1.27094 -15 2 1.45854 -0.559392 -1.19328 1.84002 -1.84978 0.0538636 -16 1 1.98052 1.0158 -0.111184 -7.14388 11.5516 -0.816233 -17 2 1.12003 1.47724 -0.140032 8.70268 -6.85942 1.26876 -18 2 2.64114 1.706 -0.201685 0.0272078 -3.57662 -0.103793 -ITEM: TIMESTEP -90 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.50003 -0.175917 1.46165 15.3898 -11.884 8.8546 -2 2 -0.608584 -0.600731 1.57129 -23.7815 11.9323 -1.75151 -3 2 -2.00991 -0.394435 2.25305 5.57059 1.55514 -7.64598 -4 1 -1.72137 -0.357368 -1.31563 -1.93902 -0.246344 7.85181 -5 2 -1.87234 -0.43987 -0.353482 -0.118832 -0.772284 -11.4834 -6 2 -2.49861 -0.682857 -1.77755 1.48512 0.513779 4.12935 -7 1 -0.579472 1.97061 -0.145894 -8.85759 -8.26094 2.77276 -8 2 -0.945449 1.52054 0.635243 4.66427 4.57627 -6.94972 -9 2 -0.952686 1.48464 -0.897126 3.60343 4.09955 4.74753 -10 1 0.988258 -1.14419 1.44127 11.1074 1.88534 -20.9154 -11 2 0.971991 -1.50516 0.531218 -4.29535 0.162687 14.3489 -12 2 1.5415 -0.356231 1.32305 -5.76468 -4.25266 5.91571 -13 1 0.969416 -1.37359 -1.35605 -1.23717 3.53556 0.174563 -14 2 0.053578 -1.1004 -1.52114 7.10928 -0.236326 1.96556 -15 2 1.49219 -0.569722 -1.21186 -5.0738 -3.24139 -1.5161 -16 1 1.97824 1.01566 -0.108279 -8.95647 8.69277 0.191958 -17 2 1.10027 1.45664 -0.104435 15.9218 -5.21388 -1.22481 -18 2 2.64464 1.70165 -0.21558 -4.82724 -2.84557 0.534172 -ITEM: TIMESTEP -100 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.4951 -0.17739 1.46185 11.6291 -12.0775 13.5087 -2 2 -0.608426 -0.588808 1.60852 -19.0988 9.4339 -4.86631 -3 2 -2.01619 -0.397996 2.24676 4.77562 3.06476 -9.1756 -4 1 -1.72287 -0.352149 -1.31567 -8.10325 -4.84048 12.8242 -5 2 -1.86729 -0.479262 -0.356777 4.49726 3.58866 -11.0242 -6 2 -2.51926 -0.676876 -1.74282 3.42966 1.20159 -1.20299 -7 1 -0.581355 1.96754 -0.149521 -5.24612 -4.66563 2.71982 -8 2 -0.935394 1.51644 0.636953 2.89489 2.96603 -9.31226 -9 2 -0.942573 1.488 -0.91114 1.96254 2.34604 7.29302 -10 1 0.988651 -1.14425 1.44045 0.840008 -1.36718 -7.83612 -11 2 0.899639 -1.53136 0.543246 5.64911 9.69241 11.7913 -12 2 1.49178 -0.318235 1.33897 -3.7582 -9.86315 -4.79205 -13 1 0.974233 -1.37573 -1.35945 -3.77942 11.331 0.435153 -14 2 0.0583408 -1.08758 -1.49668 6.15796 -3.89994 -0.197074 -15 2 1.48764 -0.558876 -1.24121 -3.14566 -8.24544 0.525665 -16 1 1.97883 1.01496 -0.10404 -9.03485 15.6667 -0.929518 -17 2 1.11471 1.47883 -0.106249 11.9101 -8.77208 -0.858699 -18 2 2.63671 1.70526 -0.232286 -1.57994 -5.55972 1.09694 diff --git a/examples/amoeba/in.ubiquitin b/examples/amoeba/in.ubiquitin index 0af52b565a..859c53e17f 100644 --- a/examples/amoeba/in.ubiquitin +++ b/examples/amoeba/in.ubiquitin @@ -14,16 +14,16 @@ improper_style amoeba # per-atom properties required by AMOEBA or HIPPO fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 + fix pit all amoeba/pitorsion fix_modify pit energy yes fix bit all amoeba/bitorsion bitorsion.ubiquitin.data fix_modify bit energy yes -fix extra all property/atom & - i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes -fix extra2 all property/atom i_polaxe +# read data file -#read_data data.ubiquitin fix amtype NULL "Tinker Types" read_data data.ubiquitin fix amtype NULL "Tinker Types" & fix pit "pitorsion types" "PiTorsion Coeffs" & fix pit pitorsions PiTorsions & diff --git a/examples/amoeba/in.ubiquitin.test b/examples/amoeba/in.ubiquitin.test deleted file mode 100644 index 859c53e17f..0000000000 --- a/examples/amoeba/in.ubiquitin.test +++ /dev/null @@ -1,56 +0,0 @@ -# solvated ubiquitin molecule with AMOEBA force field - -units real -boundary p p p -atom_modify sort 0 0.0 - -atom_style amoeba - -bond_style class2 -angle_style amoeba -dihedral_style fourier -improper_style amoeba - -# per-atom properties required by AMOEBA or HIPPO - -fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom i_amgroup d_redID d_pval ghost yes -fix extra2 all property/atom i_polaxe d2_xyzaxis 3 - -fix pit all amoeba/pitorsion -fix_modify pit energy yes -fix bit all amoeba/bitorsion bitorsion.ubiquitin.data -fix_modify bit energy yes - -# read data file - -read_data data.ubiquitin fix amtype NULL "Tinker Types" & - fix pit "pitorsion types" "PiTorsion Coeffs" & - fix pit pitorsions PiTorsions & - fix bit bitorsions BiTorsions - -pair_style amoeba -pair_coeff * * amoeba_ubiquitin.prm amoeba_ubiquitin.key - -special_bonds lj/coul 0.5 0.5 0.5 one/five yes - -# thermo output - -compute virial all pressure NULL virial - -thermo_style custom step temp epair ebond eangle edihed eimp & - emol etotal press c_virial[*] - -dump 1 all custom 10 dump.ubi id type x y z fx fy fz -dump_modify 1 sort id - -# zero step run - -#run 0 - -# dynamics - -fix 1 all nve - -thermo 1 -run 10 diff --git a/examples/amoeba/in.water_box.amoeba b/examples/amoeba/in.water_box.amoeba index 62abab1a82..ca63996264 100644 --- a/examples/amoeba/in.water_box.amoeba +++ b/examples/amoeba/in.water_box.amoeba @@ -12,7 +12,7 @@ dihedral_style none fix amtype all property/atom i_amtype ghost yes fix extra all property/atom i_amgroup d_redID d_pval ghost yes -fix extra2 all property/atom i_polaxe d_xaxis d_yaxis d_zaxis +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 # read data file diff --git a/examples/amoeba/in.water_box.amoeba.test b/examples/amoeba/in.water_box.amoeba.test deleted file mode 100644 index ca63996264..0000000000 --- a/examples/amoeba/in.water_box.amoeba.test +++ /dev/null @@ -1,47 +0,0 @@ -# water box with AMOEBA or HIPPO - -units real -boundary p p p - -atom_style amoeba -bond_style class2 -angle_style amoeba -dihedral_style none - -# per-atom properties required by AMOEBA or HIPPO - -fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom i_amgroup d_redID d_pval ghost yes -fix extra2 all property/atom i_polaxe d2_xyzaxis 3 - -# read data file - -read_data data.water_box.amoeba fix amtype NULL "Tinker Types" - -# force field - -pair_style amoeba -pair_coeff * * amoeba_water.prm amoeba_water_box.key - -special_bonds lj/coul 0.5 0.5 0.5 one/five yes - -# thermo output - -compute virial all pressure NULL virial - -thermo_style custom step temp epair ebond eangle edihed eimp & - emol etotal press c_virial[*] - -dump 1 all custom 10 dump.water_box id type x y z fx fy fz -dump_modify 1 sort id - -# zero step run - -#run 0 - -# dynamics - -fix 1 all nve - -thermo 10 -run 100 diff --git a/examples/amoeba/in.water_box.hippo b/examples/amoeba/in.water_box.hippo index 74dc6b6b08..ec1cc1cc78 100644 --- a/examples/amoeba/in.water_box.hippo +++ b/examples/amoeba/in.water_box.hippo @@ -12,7 +12,7 @@ dihedral_style none fix amtype all property/atom i_amtype ghost yes fix extra all property/atom i_amgroup d_redID d_pval ghost yes -fix extra2 all property/atom i_polaxe d_xaxis d_yaxis d_zaxis +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 # read data file diff --git a/examples/amoeba/in.water_box.hippo.test b/examples/amoeba/in.water_box.hippo.test deleted file mode 100644 index ec1cc1cc78..0000000000 --- a/examples/amoeba/in.water_box.hippo.test +++ /dev/null @@ -1,47 +0,0 @@ -# water box with AMOEBA or HIPPO - -units real -boundary p p p - -atom_style amoeba -bond_style class2 -angle_style amoeba -dihedral_style none - -# per-atom properties required by AMOEBA or HIPPO - -fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom i_amgroup d_redID d_pval ghost yes -fix extra2 all property/atom i_polaxe d2_xyzaxis 3 - -# read data file - -read_data data.water_box.hippo fix amtype NULL "Tinker Types" - -# force field - -pair_style hippo -pair_coeff * * hippo_water.prm hippo_water_box.key - -special_bonds lj/coul 0.5 0.5 0.5 one/five yes - -# thermo output - -compute virial all pressure NULL virial - -thermo_style custom step temp epair ebond eangle edihed eimp & - emol etotal press c_virial[*] - -dump 1 all custom 10 dump.water_box id type x y z fx fy fz -dump_modify 1 sort id - -# zero step run - -#run 0 - -# dynamics - -fix 1 all nve - -thermo 10 -run 100 diff --git a/examples/amoeba/in.water_dimer.amoeba b/examples/amoeba/in.water_dimer.amoeba index cee3683d56..6e388e9951 100644 --- a/examples/amoeba/in.water_dimer.amoeba +++ b/examples/amoeba/in.water_dimer.amoeba @@ -12,7 +12,7 @@ dihedral_style none fix amtype all property/atom i_amtype ghost yes fix extra all property/atom i_amgroup d_redID d_pval ghost yes -fix extra2 all property/atom i_polaxe d_xaxis d_yaxis d_zaxis +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 # read data file diff --git a/examples/amoeba/in.water_dimer.amoeba.test b/examples/amoeba/in.water_dimer.amoeba.test deleted file mode 100644 index 6e388e9951..0000000000 --- a/examples/amoeba/in.water_dimer.amoeba.test +++ /dev/null @@ -1,47 +0,0 @@ -# water dimer with AMOEBA or HIPPO - -units real -boundary s s s - -atom_style amoeba -bond_style class2 -angle_style amoeba -dihedral_style none - -# per-atom properties required by AMOEBA or HIPPO - -fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom i_amgroup d_redID d_pval ghost yes -fix extra2 all property/atom i_polaxe d2_xyzaxis 3 - -# read data file - -read_data data.water_dimer.amoeba fix amtype NULL "Tinker Types" - -# force field - -pair_style amoeba -pair_coeff * * amoeba_water.prm amoeba_water.key - -special_bonds lj/coul 0.5 0.5 0.5 one/five yes - -# thermo output - -compute virial all pressure NULL virial - -thermo_style custom step temp epair ebond eangle edihed eimp & - emol etotal press c_virial[*] - -dump 1 all custom 10 dump.water_dimer id type x y z fx fy fz -dump_modify 1 sort id - -# zero step run - -#run 0 - -# dynamics - -fix 1 all nve - -thermo 10 -run 100 diff --git a/examples/amoeba/in.water_dimer.hippo b/examples/amoeba/in.water_dimer.hippo index eab29aac9d..15a7327d5b 100644 --- a/examples/amoeba/in.water_dimer.hippo +++ b/examples/amoeba/in.water_dimer.hippo @@ -12,7 +12,7 @@ dihedral_style none fix amtype all property/atom i_amtype ghost yes fix extra all property/atom i_amgroup d_redID d_pval ghost yes -fix extra2 all property/atom i_polaxe d_xaxis d_yaxis d_zaxis +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 # read data file diff --git a/examples/amoeba/in.water_dimer.hippo.test b/examples/amoeba/in.water_dimer.hippo.test deleted file mode 100644 index 15a7327d5b..0000000000 --- a/examples/amoeba/in.water_dimer.hippo.test +++ /dev/null @@ -1,47 +0,0 @@ -# water dimer with AMOEBA or HIPPO - -units real -boundary s s s - -atom_style amoeba -bond_style class2 -angle_style amoeba -dihedral_style none - -# per-atom properties required by AMOEBA or HIPPO - -fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom i_amgroup d_redID d_pval ghost yes -fix extra2 all property/atom i_polaxe d2_xyzaxis 3 - -# read data file - -read_data data.water_dimer.hippo fix amtype NULL "Tinker Types" - -# force field - -pair_style hippo -pair_coeff * * hippo_water.prm hippo_water.key - -special_bonds lj/coul 0.5 0.5 0.5 one/five yes - -# thermo output - -compute virial all pressure NULL virial - -thermo_style custom step temp epair ebond eangle edihed eimp & - emol etotal press c_virial[*] - -dump 1 all custom 10 dump.water_dimer id type x y z fx fy fz -dump_modify 1 sort id - -# zero step run - -#run 0 - -# dynamics - -fix 1 all nve - -thermo 10 -run 100 diff --git a/examples/amoeba/in.water_hexamer.amoeba b/examples/amoeba/in.water_hexamer.amoeba index e04da7cd88..b96ec3974a 100644 --- a/examples/amoeba/in.water_hexamer.amoeba +++ b/examples/amoeba/in.water_hexamer.amoeba @@ -12,7 +12,7 @@ dihedral_style none fix amtype all property/atom i_amtype ghost yes fix extra all property/atom i_amgroup d_redID d_pval ghost yes -fix extra2 all property/atom i_polaxe d_xaxis d_yaxis d_zaxis +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 # read data file diff --git a/examples/amoeba/in.water_hexamer.amoeba.test b/examples/amoeba/in.water_hexamer.amoeba.test deleted file mode 100644 index b96ec3974a..0000000000 --- a/examples/amoeba/in.water_hexamer.amoeba.test +++ /dev/null @@ -1,47 +0,0 @@ -# water hexamer with AMOEBA or HIPPO - -units real -boundary s s s - -atom_style amoeba -bond_style class2 -angle_style amoeba -dihedral_style none - -# per-atom properties required by AMOEBA or HIPPO - -fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom i_amgroup d_redID d_pval ghost yes -fix extra2 all property/atom i_polaxe d2_xyzaxis 3 - -# read data file - -read_data data.water_hexamer.amoeba fix amtype NULL "Tinker Types" - -# force field - -pair_style amoeba -pair_coeff * * amoeba_water.prm amoeba_water.key - -special_bonds lj/coul 0.5 0.5 0.5 one/five yes - -# thermo output - -compute virial all pressure NULL virial - -thermo_style custom step temp epair ebond eangle edihed eimp & - emol etotal press c_virial[*] - -dump 1 all custom 10 dump.water_hexamer id type x y z fx fy fz -dump_modify 1 sort id - -# zero step run - -#run 0 - -# dynamics - -fix 1 all nve - -thermo 10 -run 100 diff --git a/examples/amoeba/in.water_hexamer.hippo b/examples/amoeba/in.water_hexamer.hippo index 3529b1b09c..6e4b40ffa5 100644 --- a/examples/amoeba/in.water_hexamer.hippo +++ b/examples/amoeba/in.water_hexamer.hippo @@ -12,7 +12,7 @@ dihedral_style none fix amtype all property/atom i_amtype ghost yes fix extra all property/atom i_amgroup d_redID d_pval ghost yes -fix extra2 all property/atom i_polaxe d_xaxis d_yaxis d_zaxis +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 # read data file diff --git a/examples/amoeba/in.water_hexamer.hippo.test b/examples/amoeba/in.water_hexamer.hippo.test deleted file mode 100644 index 6e4b40ffa5..0000000000 --- a/examples/amoeba/in.water_hexamer.hippo.test +++ /dev/null @@ -1,47 +0,0 @@ -# water hexamer with AMOEBA or HIPPO - -units real -boundary s s s - -atom_style amoeba -bond_style class2 -angle_style amoeba -dihedral_style none - -# per-atom properties required by AMOEBA or HIPPO - -fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom i_amgroup d_redID d_pval ghost yes -fix extra2 all property/atom i_polaxe d2_xyzaxis 3 - -# read data file - -read_data data.water_hexamer.hippo fix amtype NULL "Tinker Types" - -# force field - -pair_style hippo -pair_coeff * * hippo_water.prm hippo_water.key - -special_bonds lj/coul 0.5 0.5 0.5 one/five yes - -# thermo output - -compute virial all pressure NULL virial - -thermo_style custom step temp epair ebond eangle edihed eimp & - emol etotal press c_virial[*] - -dump 1 all custom 10 dump.water_hexamer id type x y z fx fy fz -dump_modify 1 sort id - -# zero step run - -#run 0 - -# dynamics - -fix 1 all nve - -thermo 10 -run 100 diff --git a/examples/amoeba/log.ubi.1 b/examples/amoeba/log.ubi.1 index 968a292fb5..f0c387e50b 100644 --- a/examples/amoeba/log.ubi.1 +++ b/examples/amoeba/log.ubi.1 @@ -15,15 +15,16 @@ improper_style amoeba # per-atom properties required by AMOEBA or HIPPO fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 + fix pit all amoeba/pitorsion fix_modify pit energy yes fix bit all amoeba/bitorsion bitorsion.ubiquitin.data fix_modify bit energy yes -fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes -fix extra2 all property/atom i_polaxe +# read data file -#read_data data.ubiquitin fix amtype NULL "Tinker Types" read_data data.ubiquitin fix amtype NULL "Tinker Types" fix pit "pitorsion types" "PiTorsion Coeffs" fix pit pitorsions PiTorsions fix bit bitorsions BiTorsions Reading data file ... orthogonal box = (0 0 0) to (54.99 41.91 41.91) @@ -54,7 +55,7 @@ Finding 1-2 1-3 1-4 neighbors ... 19 = max # of 1-4 neighbors 21 = max # of special neighbors special bonds CPU = 0.004 seconds - read_data CPU = 0.075 seconds + read_data CPU = 0.082 seconds pair_style amoeba pair_coeff * * amoeba_ubiquitin.prm amoeba_ubiquitin.key @@ -109,7 +110,7 @@ Neighbor list info ... stencil: half/bin/3d bin: standard AMOEBA/HIPPO group count: 3196 -Per MPI rank memory allocation (min/avg/max) = 98.55 | 98.55 | 98.55 Mbytes +Per MPI rank memory allocation (min/avg/max) = 260.4 | 260.4 | 260.4 Mbytes Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] 0 0 -35338.057 2856.5938 1955.5431 224.37609 65.00809 5101.5211 -30247.585 -6336.5196 -5795.4272 -6329.8149 -6884.3167 349.52657 77.164877 652.41925 1 29.61379 -35356.153 2037.3541 1840.7883 223.90217 64.293945 4166.3385 -30341.522 -6486.773 -6452.8463 -6841.5982 -7386.1106 311.38025 120.72605 545.35513 @@ -121,31 +122,30 @@ Per MPI rank memory allocation (min/avg/max) = 98.55 | 98.55 | 98.55 Mbytes 7 137.7204 -36521.444 782.87113 1026.745 212.04289 38.686259 2060.3452 -30479.082 -5987.83 -8386.8104 -7363.188 -7888.261 357.00835 253.66346 32.827786 8 112.66452 -36897.181 1750.0569 1269.152 210.83571 33.742799 3263.7874 -30379.432 -7886.4081 -9703.2601 -9043.015 -9555.2908 490.76046 182.31259 278.727 9 88.237359 -37209.906 2695.1766 1454.55 209.91331 29.503458 4389.1434 -30276.565 -8202.16 -9492.368 -9110.7037 -9639.2288 502.55699 107.82333 443.6705 - -AMEOBA/HIPPO timing info: - Init time: 0.0257147 0.00113515 - Hal time: 7.6011 33.5542 - Mpole time: 2.25841 9.96952 - Induce time: 8.18934 36.151 - Polar time: 4.5786 20.2117 - Total time: 22.6532 - 10 108.86756 -37474.988 2240.4603 1523.7936 209.10313 26.208515 3999.5656 -30333.279 -8468.4347 -9956.923 -9709.5874 -10224.682 365.98214 95.262991 425.12746 -Loop time of 22.6992 on 1 procs for 10 steps with 9737 atoms +Loop time of 21.791 on 1 procs for 10 steps with 9737 atoms -Performance: 0.038 ns/day, 630.534 hours/ns, 0.441 timesteps/s -98.8% CPU use with 1 MPI tasks x no OpenMP threads +Performance: 0.040 ns/day, 605.307 hours/ns, 0.459 timesteps/s +99.1% CPU use with 1 MPI tasks x no OpenMP threads + +AMEOBA/HIPPO timing breakdown: + Init time: 0.0264311 0.00121566 + Hal time: 7.15654 32.9156 + Mpole time: 2.14232 9.85334 + Induce time: 7.99277 36.7617 + Polar time: 4.42403 20.3477 + Total time: 21.7421 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 22.653 | 22.653 | 22.653 | 0.0 | 99.80 -Bond | 0.014323 | 0.014323 | 0.014323 | 0.0 | 0.06 +Pair | 21.742 | 21.742 | 21.742 | 0.0 | 99.78 +Bond | 0.014806 | 0.014806 | 0.014806 | 0.0 | 0.07 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.0035064 | 0.0035064 | 0.0035064 | 0.0 | 0.02 -Output | 0.024558 | 0.024558 | 0.024558 | 0.0 | 0.11 -Modify | 0.002901 | 0.002901 | 0.002901 | 0.0 | 0.01 -Other | | 0.0006384 | | | 0.00 +Comm | 0.0035774 | 0.0035774 | 0.0035774 | 0.0 | 0.02 +Output | 0.026947 | 0.026947 | 0.026947 | 0.0 | 0.12 +Modify | 0.0028419 | 0.0028419 | 0.0028419 | 0.0 | 0.01 +Other | | 0.0007034 | | | 0.00 Nlocal: 9737 ave 9737 max 9737 min Histogram: 1 0 0 0 0 0 0 0 0 0 @@ -159,4 +159,4 @@ Ave neighs/atom = 579.16155 Ave special neighs/atom = 3.1364897 Neighbor list builds = 0 Dangerous builds = 0 -Total wall time: 0:00:25 +Total wall time: 0:00:24 diff --git a/examples/amoeba/log.ubi.1.test b/examples/amoeba/log.ubi.1.test deleted file mode 100644 index f0c387e50b..0000000000 --- a/examples/amoeba/log.ubi.1.test +++ /dev/null @@ -1,162 +0,0 @@ -LAMMPS (24 Mar 2022) -# solvated ubiquitin molecule with AMOEBA force field - -units real -boundary p p p -atom_modify sort 0 0.0 - -atom_style amoeba - -bond_style class2 -angle_style amoeba -dihedral_style fourier -improper_style amoeba - -# per-atom properties required by AMOEBA or HIPPO - -fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom i_amgroup d_redID d_pval ghost yes -fix extra2 all property/atom i_polaxe d2_xyzaxis 3 - -fix pit all amoeba/pitorsion -fix_modify pit energy yes -fix bit all amoeba/bitorsion bitorsion.ubiquitin.data -fix_modify bit energy yes - -# read data file - -read_data data.ubiquitin fix amtype NULL "Tinker Types" fix pit "pitorsion types" "PiTorsion Coeffs" fix pit pitorsions PiTorsions fix bit bitorsions BiTorsions -Reading data file ... - orthogonal box = (0 0 0) to (54.99 41.91 41.91) - 1 by 1 by 1 MPI processor grid - reading atoms ... - 9737 atoms - scanning bonds ... - 4 = max bonds/atom - scanning angles ... - 6 = max angles/atom - scanning dihedrals ... - 18 = max dihedrals/atom - scanning impropers ... - 3 = max impropers/atom - reading bonds ... - 6908 bonds - reading angles ... - 5094 angles - reading dihedrals ... - 3297 dihedrals - reading impropers ... - 651 impropers -Finding 1-2 1-3 1-4 neighbors ... - special bond factors lj: 0 0 0 - special bond factors coul: 0 0 0 - 4 = max # of 1-2 neighbors - 9 = max # of 1-3 neighbors - 19 = max # of 1-4 neighbors - 21 = max # of special neighbors - special bonds CPU = 0.004 seconds - read_data CPU = 0.082 seconds - -pair_style amoeba -pair_coeff * * amoeba_ubiquitin.prm amoeba_ubiquitin.key - -special_bonds lj/coul 0.5 0.5 0.5 one/five yes -Finding 1-2 1-3 1-4 neighbors ... - special bond factors lj: 0.5 0.5 0.5 - special bond factors coul: 0.5 0.5 0.5 - 4 = max # of 1-2 neighbors - 9 = max # of 1-3 neighbors - 19 = max # of 1-4 neighbors - 58 = max # of 1-5 neighbors - 21 = max # of special neighbors - special bonds CPU = 0.006 seconds - -# thermo output - -compute virial all pressure NULL virial - -thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] - -dump 1 all custom 10 dump.ubi id type x y z fx fy fz -dump_modify 1 sort id - -# zero step run - -#run 0 - -# dynamics - -fix 1 all nve - -thermo 1 -run 10 -AMOEBA/HIPPO force field settings - hal: cut 12 taper 10.8 vscale 0 0 1 1 - multipole: cut 7 aewald 0.4 bsorder 5 FFT 60 48 48 mscale 0 0 0.4 1 - polar: cut 7 aewald 0.5 bsorder 5 FFT 60 48 48 - pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 1 1 1 1 d/u scale 0 1 - precondition: cut 4.5 - generated 0 of 15 mixed pair_coeff terms from geometric mixing rule -Neighbor list info ... - update every 1 steps, delay 10 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 14 - ghost atom cutoff = 14 - binsize = 7, bins = 8 6 6 - 1 neighbor lists, perpetual/occasional/extra = 1 0 0 - (1) pair amoeba, perpetual - attributes: half, newton on - pair build: half/bin/newton - stencil: half/bin/3d - bin: standard - AMOEBA/HIPPO group count: 3196 -Per MPI rank memory allocation (min/avg/max) = 260.4 | 260.4 | 260.4 Mbytes - Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] - 0 0 -35338.057 2856.5938 1955.5431 224.37609 65.00809 5101.5211 -30247.585 -6336.5196 -5795.4272 -6329.8149 -6884.3167 349.52657 77.164877 652.41925 - 1 29.61379 -35356.153 2037.3541 1840.7883 223.90217 64.293945 4166.3385 -30341.522 -6486.773 -6452.8463 -6841.5982 -7386.1106 311.38025 120.72605 545.35513 - 2 78.518242 -35383.65 825.39919 1538.3909 222.55095 62.191009 2648.5321 -30467.814 -5502.9841 -6410.2998 -6396.1829 -6937.8137 217.3515 210.76948 294.28051 - 3 88.8921 -35402.11 938.99299 1162.2914 220.5271 58.832521 2380.644 -30453.516 -1929.5417 -3331.1291 -2769.7218 -3350.5733 117.32302 279.72705 31.237776 - 4 68.740402 -35477.589 2048.0659 858.03795 218.14277 54.460022 3178.7066 -30316.325 2041.1138 594.25938 1665.7799 1030.8539 66.230421 304.28296 -155.80224 - 5 76.267862 -35707.869 2206.6534 736.37385 215.75693 49.401674 3208.1859 -30299.377 2276.9276 536.21124 1893.4621 1258.492 92.097191 299.65604 -228.58369 - 6 118.24373 -36092.77 1166.179 815.59206 213.67399 44.022297 2239.4673 -30435.629 -1677.8051 -3988.2428 -2669.6848 -3247.7207 197.42472 285.87129 -162.35459 - 7 137.7204 -36521.444 782.87113 1026.745 212.04289 38.686259 2060.3452 -30479.082 -5987.83 -8386.8104 -7363.188 -7888.261 357.00835 253.66346 32.827786 - 8 112.66452 -36897.181 1750.0569 1269.152 210.83571 33.742799 3263.7874 -30379.432 -7886.4081 -9703.2601 -9043.015 -9555.2908 490.76046 182.31259 278.727 - 9 88.237359 -37209.906 2695.1766 1454.55 209.91331 29.503458 4389.1434 -30276.565 -8202.16 -9492.368 -9110.7037 -9639.2288 502.55699 107.82333 443.6705 - 10 108.86756 -37474.988 2240.4603 1523.7936 209.10313 26.208515 3999.5656 -30333.279 -8468.4347 -9956.923 -9709.5874 -10224.682 365.98214 95.262991 425.12746 -Loop time of 21.791 on 1 procs for 10 steps with 9737 atoms - -Performance: 0.040 ns/day, 605.307 hours/ns, 0.459 timesteps/s -99.1% CPU use with 1 MPI tasks x no OpenMP threads - -AMEOBA/HIPPO timing breakdown: - Init time: 0.0264311 0.00121566 - Hal time: 7.15654 32.9156 - Mpole time: 2.14232 9.85334 - Induce time: 7.99277 36.7617 - Polar time: 4.42403 20.3477 - Total time: 21.7421 - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 21.742 | 21.742 | 21.742 | 0.0 | 99.78 -Bond | 0.014806 | 0.014806 | 0.014806 | 0.0 | 0.07 -Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.0035774 | 0.0035774 | 0.0035774 | 0.0 | 0.02 -Output | 0.026947 | 0.026947 | 0.026947 | 0.0 | 0.12 -Modify | 0.0028419 | 0.0028419 | 0.0028419 | 0.0 | 0.01 -Other | | 0.0007034 | | | 0.00 - -Nlocal: 9737 ave 9737 max 9737 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Nghost: 31511 ave 31511 max 31511 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Neighs: 5.6393e+06 ave 5.6393e+06 max 5.6393e+06 min -Histogram: 1 0 0 0 0 0 0 0 0 0 - -Total # of neighbors = 5639296 -Ave neighs/atom = 579.16155 -Ave special neighs/atom = 3.1364897 -Neighbor list builds = 0 -Dangerous builds = 0 -Total wall time: 0:00:24 diff --git a/examples/amoeba/log.ubi.32 b/examples/amoeba/log.ubi.32 index 6a21c3cb16..b0bc4b381e 100644 --- a/examples/amoeba/log.ubi.32 +++ b/examples/amoeba/log.ubi.32 @@ -15,15 +15,16 @@ improper_style amoeba # per-atom properties required by AMOEBA or HIPPO fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 + fix pit all amoeba/pitorsion fix_modify pit energy yes fix bit all amoeba/bitorsion bitorsion.ubiquitin.data fix_modify bit energy yes -fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes -fix extra2 all property/atom i_polaxe +# read data file -#read_data data.ubiquitin fix amtype NULL "Tinker Types" read_data data.ubiquitin fix amtype NULL "Tinker Types" fix pit "pitorsion types" "PiTorsion Coeffs" fix pit pitorsions PiTorsions fix bit bitorsions BiTorsions Reading data file ... orthogonal box = (0 0 0) to (54.99 41.91 41.91) @@ -54,7 +55,7 @@ Finding 1-2 1-3 1-4 neighbors ... 19 = max # of 1-4 neighbors 21 = max # of special neighbors special bonds CPU = 0.002 seconds - read_data CPU = 0.125 seconds + read_data CPU = 0.112 seconds pair_style amoeba pair_coeff * * amoeba_ubiquitin.prm amoeba_ubiquitin.key @@ -109,7 +110,7 @@ Neighbor list info ... stencil: half/bin/3d bin: standard AMOEBA/HIPPO group count: 3196 -Per MPI rank memory allocation (min/avg/max) = 26.19 | 26.49 | 27.59 Mbytes +Per MPI rank memory allocation (min/avg/max) = 73.46 | 73.76 | 74.86 Mbytes Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] 0 0 -35338.057 2856.5938 1955.5431 224.37609 65.00809 5101.5211 -30247.585 -6336.5196 -5795.4272 -6329.8149 -6884.3167 349.52657 77.164877 652.41925 1 29.61379 -35356.153 2037.3541 1840.7883 223.90217 64.293945 4166.3385 -30341.522 -6486.773 -6452.8463 -6841.5982 -7386.1106 311.38025 120.72605 545.35513 @@ -121,31 +122,30 @@ Per MPI rank memory allocation (min/avg/max) = 26.19 | 26.49 | 27.59 Mbytes 7 137.7204 -36521.444 782.87113 1026.745 212.04289 38.686259 2060.3452 -30479.082 -5987.83 -8386.8104 -7363.188 -7888.261 357.00835 253.66346 32.827786 8 112.66452 -36897.181 1750.0569 1269.152 210.83571 33.742799 3263.7874 -30379.432 -7886.4081 -9703.2601 -9043.015 -9555.2908 490.76046 182.31259 278.727 9 88.237359 -37209.906 2695.1766 1454.55 209.91331 29.503458 4389.1434 -30276.565 -8202.16 -9492.368 -9110.7037 -9639.2288 502.55699 107.82333 443.6705 - -AMEOBA/HIPPO timing info: - Init time: 0.0350369 0.0194083 - Hal time: 0.274414 15.2009 - Mpole time: 0.209885 11.6263 - Induce time: 1.00414 55.6234 - Polar time: 0.281769 15.6083 - Total time: 1.80525 - 10 108.86756 -37474.988 2240.4603 1523.7936 209.10313 26.208515 3999.5656 -30333.279 -8468.4347 -9956.923 -9709.5874 -10224.682 365.98214 95.262991 425.12746 -Loop time of 1.82311 on 32 procs for 10 steps with 9737 atoms +Loop time of 1.51355 on 32 procs for 10 steps with 9737 atoms -Performance: 0.474 ns/day, 50.642 hours/ns, 5.485 timesteps/s -99.1% CPU use with 32 MPI tasks x no OpenMP threads +Performance: 0.571 ns/day, 42.043 hours/ns, 6.607 timesteps/s +99.5% CPU use with 32 MPI tasks x no OpenMP threads + +AMEOBA/HIPPO timing breakdown: + Init time: 0.0221241 0.0147382 + Hal time: 0.27487 18.3107 + Mpole time: 0.1964 13.0833 + Induce time: 0.743514 49.5298 + Polar time: 0.264231 17.602 + Total time: 1.50114 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 1.805 | 1.8057 | 1.8065 | 0.0 | 99.05 -Bond | 0.00027 | 0.00076775 | 0.0023491 | 0.0 | 0.04 +Pair | 1.5006 | 1.5014 | 1.5026 | 0.1 | 99.20 +Bond | 0.00023121 | 0.0006371 | 0.002095 | 0.0 | 0.04 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.0098412 | 0.011853 | 0.013048 | 0.8 | 0.65 -Output | 0.0038478 | 0.0041268 | 0.0045236 | 0.2 | 0.23 -Modify | 0.00019451 | 0.00034384 | 0.00063207 | 0.0 | 0.02 -Other | | 0.0003186 | | | 0.02 +Comm | 0.0060146 | 0.008046 | 0.0092638 | 1.0 | 0.53 +Output | 0.0028415 | 0.0030424 | 0.003441 | 0.2 | 0.20 +Modify | 0.00011709 | 0.00019911 | 0.00036104 | 0.0 | 0.01 +Other | | 0.0002509 | | | 0.02 Nlocal: 304.281 ave 326 max 273 min Histogram: 1 1 0 5 2 8 3 6 4 2 @@ -159,4 +159,4 @@ Ave neighs/atom = 579.16155 Ave special neighs/atom = 3.1364897 Neighbor list builds = 0 Dangerous builds = 0 -Total wall time: 0:00:02 +Total wall time: 0:00:01 diff --git a/examples/amoeba/log.ubi.32.test b/examples/amoeba/log.ubi.32.test deleted file mode 100644 index b0bc4b381e..0000000000 --- a/examples/amoeba/log.ubi.32.test +++ /dev/null @@ -1,162 +0,0 @@ -LAMMPS (24 Mar 2022) -# solvated ubiquitin molecule with AMOEBA force field - -units real -boundary p p p -atom_modify sort 0 0.0 - -atom_style amoeba - -bond_style class2 -angle_style amoeba -dihedral_style fourier -improper_style amoeba - -# per-atom properties required by AMOEBA or HIPPO - -fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom i_amgroup d_redID d_pval ghost yes -fix extra2 all property/atom i_polaxe d2_xyzaxis 3 - -fix pit all amoeba/pitorsion -fix_modify pit energy yes -fix bit all amoeba/bitorsion bitorsion.ubiquitin.data -fix_modify bit energy yes - -# read data file - -read_data data.ubiquitin fix amtype NULL "Tinker Types" fix pit "pitorsion types" "PiTorsion Coeffs" fix pit pitorsions PiTorsions fix bit bitorsions BiTorsions -Reading data file ... - orthogonal box = (0 0 0) to (54.99 41.91 41.91) - 4 by 2 by 4 MPI processor grid - reading atoms ... - 9737 atoms - scanning bonds ... - 4 = max bonds/atom - scanning angles ... - 6 = max angles/atom - scanning dihedrals ... - 18 = max dihedrals/atom - scanning impropers ... - 3 = max impropers/atom - reading bonds ... - 6908 bonds - reading angles ... - 5094 angles - reading dihedrals ... - 3297 dihedrals - reading impropers ... - 651 impropers -Finding 1-2 1-3 1-4 neighbors ... - special bond factors lj: 0 0 0 - special bond factors coul: 0 0 0 - 4 = max # of 1-2 neighbors - 9 = max # of 1-3 neighbors - 19 = max # of 1-4 neighbors - 21 = max # of special neighbors - special bonds CPU = 0.002 seconds - read_data CPU = 0.112 seconds - -pair_style amoeba -pair_coeff * * amoeba_ubiquitin.prm amoeba_ubiquitin.key - -special_bonds lj/coul 0.5 0.5 0.5 one/five yes -Finding 1-2 1-3 1-4 neighbors ... - special bond factors lj: 0.5 0.5 0.5 - special bond factors coul: 0.5 0.5 0.5 - 4 = max # of 1-2 neighbors - 9 = max # of 1-3 neighbors - 19 = max # of 1-4 neighbors - 58 = max # of 1-5 neighbors - 21 = max # of special neighbors - special bonds CPU = 0.002 seconds - -# thermo output - -compute virial all pressure NULL virial - -thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] - -dump 1 all custom 10 dump.ubi id type x y z fx fy fz -dump_modify 1 sort id - -# zero step run - -#run 0 - -# dynamics - -fix 1 all nve - -thermo 1 -run 10 -AMOEBA/HIPPO force field settings - hal: cut 12 taper 10.8 vscale 0 0 1 1 - multipole: cut 7 aewald 0.4 bsorder 5 FFT 60 48 48 mscale 0 0 0.4 1 - polar: cut 7 aewald 0.5 bsorder 5 FFT 60 48 48 - pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 1 1 1 1 d/u scale 0 1 - precondition: cut 4.5 - generated 0 of 15 mixed pair_coeff terms from geometric mixing rule -Neighbor list info ... - update every 1 steps, delay 10 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 14 - ghost atom cutoff = 14 - binsize = 7, bins = 8 6 6 - 1 neighbor lists, perpetual/occasional/extra = 1 0 0 - (1) pair amoeba, perpetual - attributes: half, newton on - pair build: half/bin/newton - stencil: half/bin/3d - bin: standard - AMOEBA/HIPPO group count: 3196 -Per MPI rank memory allocation (min/avg/max) = 73.46 | 73.76 | 74.86 Mbytes - Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] - 0 0 -35338.057 2856.5938 1955.5431 224.37609 65.00809 5101.5211 -30247.585 -6336.5196 -5795.4272 -6329.8149 -6884.3167 349.52657 77.164877 652.41925 - 1 29.61379 -35356.153 2037.3541 1840.7883 223.90217 64.293945 4166.3385 -30341.522 -6486.773 -6452.8463 -6841.5982 -7386.1106 311.38025 120.72605 545.35513 - 2 78.518242 -35383.65 825.39919 1538.3909 222.55095 62.191009 2648.5321 -30467.814 -5502.9841 -6410.2998 -6396.1829 -6937.8137 217.3515 210.76948 294.28051 - 3 88.8921 -35402.11 938.99299 1162.2914 220.5271 58.832521 2380.644 -30453.516 -1929.5417 -3331.1291 -2769.7218 -3350.5733 117.32302 279.72705 31.237776 - 4 68.740402 -35477.589 2048.0659 858.03795 218.14277 54.460022 3178.7066 -30316.325 2041.1138 594.25938 1665.7799 1030.8539 66.230421 304.28296 -155.80224 - 5 76.267862 -35707.869 2206.6534 736.37385 215.75693 49.401674 3208.1859 -30299.377 2276.9276 536.21124 1893.4621 1258.492 92.097191 299.65604 -228.58369 - 6 118.24373 -36092.77 1166.179 815.59206 213.67399 44.022297 2239.4673 -30435.629 -1677.8051 -3988.2428 -2669.6848 -3247.7207 197.42472 285.87129 -162.35459 - 7 137.7204 -36521.444 782.87113 1026.745 212.04289 38.686259 2060.3452 -30479.082 -5987.83 -8386.8104 -7363.188 -7888.261 357.00835 253.66346 32.827786 - 8 112.66452 -36897.181 1750.0569 1269.152 210.83571 33.742799 3263.7874 -30379.432 -7886.4081 -9703.2601 -9043.015 -9555.2908 490.76046 182.31259 278.727 - 9 88.237359 -37209.906 2695.1766 1454.55 209.91331 29.503458 4389.1434 -30276.565 -8202.16 -9492.368 -9110.7037 -9639.2288 502.55699 107.82333 443.6705 - 10 108.86756 -37474.988 2240.4603 1523.7936 209.10313 26.208515 3999.5656 -30333.279 -8468.4347 -9956.923 -9709.5874 -10224.682 365.98214 95.262991 425.12746 -Loop time of 1.51355 on 32 procs for 10 steps with 9737 atoms - -Performance: 0.571 ns/day, 42.043 hours/ns, 6.607 timesteps/s -99.5% CPU use with 32 MPI tasks x no OpenMP threads - -AMEOBA/HIPPO timing breakdown: - Init time: 0.0221241 0.0147382 - Hal time: 0.27487 18.3107 - Mpole time: 0.1964 13.0833 - Induce time: 0.743514 49.5298 - Polar time: 0.264231 17.602 - Total time: 1.50114 - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 1.5006 | 1.5014 | 1.5026 | 0.1 | 99.20 -Bond | 0.00023121 | 0.0006371 | 0.002095 | 0.0 | 0.04 -Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.0060146 | 0.008046 | 0.0092638 | 1.0 | 0.53 -Output | 0.0028415 | 0.0030424 | 0.003441 | 0.2 | 0.20 -Modify | 0.00011709 | 0.00019911 | 0.00036104 | 0.0 | 0.01 -Other | | 0.0002509 | | | 0.02 - -Nlocal: 304.281 ave 326 max 273 min -Histogram: 1 1 0 5 2 8 3 6 4 2 -Nghost: 7618.59 ave 7678 max 7545 min -Histogram: 1 1 4 4 5 5 2 2 4 4 -Neighs: 176228 ave 204476 max 149390 min -Histogram: 3 3 3 2 6 2 5 4 2 2 - -Total # of neighbors = 5639296 -Ave neighs/atom = 579.16155 -Ave special neighs/atom = 3.1364897 -Neighbor list builds = 0 -Dangerous builds = 0 -Total wall time: 0:00:01 diff --git a/examples/amoeba/log.water_box.amoeba.1 b/examples/amoeba/log.water_box.amoeba.1 index f8f887d800..8f81eaaf42 100644 --- a/examples/amoeba/log.water_box.amoeba.1 +++ b/examples/amoeba/log.water_box.amoeba.1 @@ -12,8 +12,8 @@ dihedral_style none # per-atom properties required by AMOEBA or HIPPO fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes -fix extra2 all property/atom i_polaxe +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 # read data file @@ -39,7 +39,7 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of special neighbors special bonds CPU = 0.000 seconds - read_data CPU = 0.011 seconds + read_data CPU = 0.012 seconds # force field @@ -96,7 +96,7 @@ Neighbor list info ... stencil: half/bin/3d bin: standard AMOEBA/HIPPO group count: 216 -Per MPI rank memory allocation (min/avg/max) = 10.9 | 10.9 | 10.9 Mbytes +Per MPI rank memory allocation (min/avg/max) = 58.28 | 58.28 | 58.28 Mbytes Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] 0 0 -2172.0441 166.82637 83.732524 0 0 250.5589 -1921.4852 -6181.7112 -4771.8292 -6955.3278 -6817.9765 -272.19746 3173.3487 2229.6526 10 105.50439 -2373.6865 136.67908 106.86552 0 0 243.54459 -1926.6678 -8441.2174 -10450.318 -9514.124 -9665.625 -301.45304 322.2435 1916.9694 @@ -108,31 +108,30 @@ Per MPI rank memory allocation (min/avg/max) = 10.9 | 10.9 | 10.9 Mbytes 70 166.70629 -2383.4827 76.492455 55.020922 0 0 131.51338 -1930.4622 4743.9587 1916.6786 2839.9241 2670.7568 -169.67855 -187.58379 -2256.4529 80 171.82933 -2388.0347 76.463333 49.138785 0 0 125.60212 -1931.0453 2210.1222 -319.99043 330.98785 -394.25628 -44.858027 252.35533 -1985.0908 90 175.7327 -2423.7974 90.784969 63.725029 0 0 154.51 -1930.3722 -917.58179 -3941.9566 -2568.4278 -3415.3121 196.38051 2366.2885 -263.52434 - -AMEOBA/HIPPO timing info: - Init time: 0.0251099 0.000637177 - Hal time: 0.924614 2.34626 - Mpole time: 2.51306 6.37702 - Induce time: 29.8839 75.8319 - Polar time: 6.06136 15.381 - Total time: 39.408 - 100 173.73319 -2422.3616 99.761403 57.29505 0 0 157.05645 -1930.2461 -3586.4169 -5733.9943 -5881.4025 -6235.1905 -230.75166 959.02899 406.2349 -Loop time of 39.4372 on 1 procs for 100 steps with 648 atoms +Loop time of 38.7603 on 1 procs for 100 steps with 648 atoms -Performance: 0.219 ns/day, 109.548 hours/ns, 2.536 timesteps/s +Performance: 0.223 ns/day, 107.668 hours/ns, 2.580 timesteps/s 99.6% CPU use with 1 MPI tasks x no OpenMP threads +AMEOBA/HIPPO timing breakdown: + Init time: 0.0258209 0.000666708 + Hal time: 0.889324 2.29628 + Mpole time: 2.44816 6.32126 + Induce time: 29.4141 75.9487 + Polar time: 5.95145 15.3669 + Total time: 38.7289 + MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 39.408 | 39.408 | 39.408 | 0.0 | 99.93 -Bond | 0.0033709 | 0.0033709 | 0.0033709 | 0.0 | 0.01 -Neigh | 0.0054251 | 0.0054251 | 0.0054251 | 0.0 | 0.01 -Comm | 0.0035919 | 0.0035919 | 0.0035919 | 0.0 | 0.01 -Output | 0.014523 | 0.014523 | 0.014523 | 0.0 | 0.04 -Modify | 0.00095298 | 0.00095298 | 0.00095298 | 0.0 | 0.00 -Other | | 0.001005 | | | 0.00 +Pair | 38.729 | 38.729 | 38.729 | 0.0 | 99.92 +Bond | 0.003226 | 0.003226 | 0.003226 | 0.0 | 0.01 +Neigh | 0.0054679 | 0.0054679 | 0.0054679 | 0.0 | 0.01 +Comm | 0.0036497 | 0.0036497 | 0.0036497 | 0.0 | 0.01 +Output | 0.01663 | 0.01663 | 0.01663 | 0.0 | 0.04 +Modify | 0.00088965 | 0.00088965 | 0.00088965 | 0.0 | 0.00 +Other | | 0.001155 | | | 0.00 Nlocal: 648 ave 648 max 648 min Histogram: 1 0 0 0 0 0 0 0 0 0 @@ -146,4 +145,4 @@ Ave neighs/atom = 152.07253 Ave special neighs/atom = 2 Neighbor list builds = 2 Dangerous builds = 0 -Total wall time: 0:00:40 +Total wall time: 0:00:39 diff --git a/examples/amoeba/log.water_box.amoeba.1.test b/examples/amoeba/log.water_box.amoeba.1.test deleted file mode 100644 index 8f81eaaf42..0000000000 --- a/examples/amoeba/log.water_box.amoeba.1.test +++ /dev/null @@ -1,148 +0,0 @@ -LAMMPS (24 Mar 2022) -# water box with AMOEBA or HIPPO - -units real -boundary p p p - -atom_style amoeba -bond_style class2 -angle_style amoeba -dihedral_style none - -# per-atom properties required by AMOEBA or HIPPO - -fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom i_amgroup d_redID d_pval ghost yes -fix extra2 all property/atom i_polaxe d2_xyzaxis 3 - -# read data file - -read_data data.water_box.amoeba fix amtype NULL "Tinker Types" -Reading data file ... - orthogonal box = (0 0 0) to (18.643 18.643 18.643) - 1 by 1 by 1 MPI processor grid - reading atoms ... - 648 atoms - scanning bonds ... - 2 = max bonds/atom - scanning angles ... - 1 = max angles/atom - reading bonds ... - 432 bonds - reading angles ... - 216 angles -Finding 1-2 1-3 1-4 neighbors ... - special bond factors lj: 0 0 0 - special bond factors coul: 0 0 0 - 2 = max # of 1-2 neighbors - 1 = max # of 1-3 neighbors - 1 = max # of 1-4 neighbors - 2 = max # of special neighbors - special bonds CPU = 0.000 seconds - read_data CPU = 0.012 seconds - -# force field - -pair_style amoeba -pair_coeff * * amoeba_water.prm amoeba_water_box.key - -special_bonds lj/coul 0.5 0.5 0.5 one/five yes -Finding 1-2 1-3 1-4 neighbors ... - special bond factors lj: 0.5 0.5 0.5 - special bond factors coul: 0.5 0.5 0.5 - 2 = max # of 1-2 neighbors - 1 = max # of 1-3 neighbors - 1 = max # of 1-4 neighbors - 2 = max # of 1-5 neighbors - 2 = max # of special neighbors - special bonds CPU = 0.001 seconds - -# thermo output - -compute virial all pressure NULL virial - -thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] - -dump 1 all custom 10 dump.water_box id type x y z fx fy fz -dump_modify 1 sort id - -# zero step run - -#run 0 - -# dynamics - -fix 1 all nve - -thermo 10 -run 100 -AMOEBA/HIPPO force field settings - hal: cut 7 taper 6 vscale 0 0 1 1 - multipole: cut 7 aewald 0.4 bsorder 5 FFT 50 50 50 mscale 0 0 0.4 1 - polar: cut 7 aewald 0.5 bsorder 5 FFT 50 50 50 - pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 1 1 1 1 d/u scale 0 1 - precondition: cut 4.5 - generated 0 of 1 mixed pair_coeff terms from geometric mixing rule -Neighbor list info ... - update every 1 steps, delay 10 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 9 - ghost atom cutoff = 9 - binsize = 4.5, bins = 5 5 5 - 1 neighbor lists, perpetual/occasional/extra = 1 0 0 - (1) pair amoeba, perpetual - attributes: half, newton on - pair build: half/bin/newton - stencil: half/bin/3d - bin: standard - AMOEBA/HIPPO group count: 216 -Per MPI rank memory allocation (min/avg/max) = 58.28 | 58.28 | 58.28 Mbytes - Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] - 0 0 -2172.0441 166.82637 83.732524 0 0 250.5589 -1921.4852 -6181.7112 -4771.8292 -6955.3278 -6817.9765 -272.19746 3173.3487 2229.6526 - 10 105.50439 -2373.6865 136.67908 106.86552 0 0 243.54459 -1926.6678 -8441.2174 -10450.318 -9514.124 -9665.625 -301.45304 322.2435 1916.9694 - 20 143.90097 -2358.3516 70.951764 76.777106 0 0 147.72887 -1933.0976 -7370.463 -7728.4884 -11580.562 -8676.0017 -807.21546 780.4123 2096.7667 - 30 157.22768 -2375.4639 50.396281 87.108719 0 0 137.505 -1934.7321 -4449.9504 -6946.5881 -7865.3435 -4955.5443 -417.85139 -1004.0926 -36.630383 - 40 150.92709 -2354.1768 78.484257 53.799494 0 0 132.28375 -1930.8175 353.40845 -939.7978 -4636.1858 475.75837 -1074.4762 -1584.304 -574.27211 - 50 153.02614 -2388.7287 100.20124 65.814409 0 0 166.01565 -1927.5893 3975.1595 1366.008 426.2343 3887.1078 -1807.1658 -2534.8393 -2118.6912 - 60 155.01798 -2364.31 92.948309 44.252938 0 0 137.20125 -1928.1435 5793.7978 3521.2541 1421.9416 6110.7678 -1536.937 -2559.5674 -1502.2038 - 70 166.70629 -2383.4827 76.492455 55.020922 0 0 131.51338 -1930.4622 4743.9587 1916.6786 2839.9241 2670.7568 -169.67855 -187.58379 -2256.4529 - 80 171.82933 -2388.0347 76.463333 49.138785 0 0 125.60212 -1931.0453 2210.1222 -319.99043 330.98785 -394.25628 -44.858027 252.35533 -1985.0908 - 90 175.7327 -2423.7974 90.784969 63.725029 0 0 154.51 -1930.3722 -917.58179 -3941.9566 -2568.4278 -3415.3121 196.38051 2366.2885 -263.52434 - 100 173.73319 -2422.3616 99.761403 57.29505 0 0 157.05645 -1930.2461 -3586.4169 -5733.9943 -5881.4025 -6235.1905 -230.75166 959.02899 406.2349 -Loop time of 38.7603 on 1 procs for 100 steps with 648 atoms - -Performance: 0.223 ns/day, 107.668 hours/ns, 2.580 timesteps/s -99.6% CPU use with 1 MPI tasks x no OpenMP threads - -AMEOBA/HIPPO timing breakdown: - Init time: 0.0258209 0.000666708 - Hal time: 0.889324 2.29628 - Mpole time: 2.44816 6.32126 - Induce time: 29.4141 75.9487 - Polar time: 5.95145 15.3669 - Total time: 38.7289 - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 38.729 | 38.729 | 38.729 | 0.0 | 99.92 -Bond | 0.003226 | 0.003226 | 0.003226 | 0.0 | 0.01 -Neigh | 0.0054679 | 0.0054679 | 0.0054679 | 0.0 | 0.01 -Comm | 0.0036497 | 0.0036497 | 0.0036497 | 0.0 | 0.01 -Output | 0.01663 | 0.01663 | 0.01663 | 0.0 | 0.04 -Modify | 0.00088965 | 0.00088965 | 0.00088965 | 0.0 | 0.00 -Other | | 0.001155 | | | 0.00 - -Nlocal: 648 ave 648 max 648 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Nghost: 4290 ave 4290 max 4290 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Neighs: 98543 ave 98543 max 98543 min -Histogram: 1 0 0 0 0 0 0 0 0 0 - -Total # of neighbors = 98543 -Ave neighs/atom = 152.07253 -Ave special neighs/atom = 2 -Neighbor list builds = 2 -Dangerous builds = 0 -Total wall time: 0:00:39 diff --git a/examples/amoeba/log.water_box.amoeba.32 b/examples/amoeba/log.water_box.amoeba.32 index 859e13e229..16a0168dac 100644 --- a/examples/amoeba/log.water_box.amoeba.32 +++ b/examples/amoeba/log.water_box.amoeba.32 @@ -12,8 +12,8 @@ dihedral_style none # per-atom properties required by AMOEBA or HIPPO fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes -fix extra2 all property/atom i_polaxe +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 # read data file @@ -39,7 +39,7 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of special neighbors special bonds CPU = 0.002 seconds - read_data CPU = 0.027 seconds + read_data CPU = 0.020 seconds # force field @@ -55,7 +55,7 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of 1-5 neighbors 2 = max # of special neighbors - special bonds CPU = 0.002 seconds + special bonds CPU = 0.001 seconds # thermo output @@ -96,7 +96,7 @@ Neighbor list info ... stencil: half/bin/3d bin: standard AMOEBA/HIPPO group count: 216 -Per MPI rank memory allocation (min/avg/max) = 10.07 | 10.08 | 10.34 Mbytes +Per MPI rank memory allocation (min/avg/max) = 57.47 | 57.48 | 57.74 Mbytes Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] 0 0 -2172.0441 166.82637 83.732524 0 0 250.5589 -1921.4852 -6181.7112 -4771.8292 -6955.3278 -6817.9765 -272.19746 3173.3487 2229.6526 10 105.50439 -2373.6865 136.67908 106.86552 0 0 243.54459 -1926.6678 -8441.2174 -10450.318 -9514.124 -9665.625 -301.45304 322.2435 1916.9694 @@ -108,31 +108,30 @@ Per MPI rank memory allocation (min/avg/max) = 10.07 | 10.08 | 10.34 Mbytes 70 166.70629 -2383.4827 76.492455 55.020922 0 0 131.51338 -1930.4622 4743.9587 1916.6786 2839.9241 2670.7568 -169.67855 -187.58379 -2256.4529 80 171.82933 -2388.0347 76.463333 49.138785 0 0 125.60212 -1931.0453 2210.1222 -319.99043 330.98785 -394.25628 -44.858027 252.35533 -1985.0908 90 175.7327 -2423.7974 90.784969 63.725029 0 0 154.51 -1930.3722 -917.58179 -3941.9566 -2568.4278 -3415.3121 196.38051 2366.2885 -263.52434 - -AMEOBA/HIPPO timing info: - Init time: 0.0525488 0.00776173 - Hal time: 0.037136 0.548518 - Mpole time: 0.586998 8.67026 - Induce time: 5.01628 74.093 - Polar time: 1.07725 15.9116 - Total time: 6.77025 - 100 173.73319 -2422.3616 99.761403 57.29505 0 0 157.05645 -1930.2461 -3586.4169 -5733.9943 -5881.4025 -6235.1905 -230.75166 959.02899 406.2349 -Loop time of 6.80378 on 32 procs for 100 steps with 648 atoms +Loop time of 6.48935 on 32 procs for 100 steps with 648 atoms -Performance: 1.270 ns/day, 18.899 hours/ns, 14.698 timesteps/s -99.7% CPU use with 32 MPI tasks x no OpenMP threads +Performance: 1.331 ns/day, 18.026 hours/ns, 15.410 timesteps/s +99.8% CPU use with 32 MPI tasks x no OpenMP threads + +AMEOBA/HIPPO timing breakdown: + Init time: 0.0357484 0.00553355 + Hal time: 0.0364815 0.564704 + Mpole time: 0.541384 8.38018 + Induce time: 4.89091 75.7073 + Polar time: 0.955739 14.794 + Total time: 6.46029 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 6.7643 | 6.7717 | 6.779 | 0.2 | 99.53 -Bond | 0.00031311 | 0.00044449 | 0.00060974 | 0.0 | 0.01 -Neigh | 0.00039627 | 0.00047385 | 0.00058355 | 0.0 | 0.01 -Comm | 0.018079 | 0.025388 | 0.03285 | 2.6 | 0.37 -Output | 0.0036767 | 0.0037103 | 0.0039596 | 0.1 | 0.05 -Modify | 0.00040095 | 0.00049993 | 0.00061333 | 0.0 | 0.01 -Other | | 0.001545 | | | 0.02 +Pair | 6.4536 | 6.4614 | 6.4698 | 0.2 | 99.57 +Bond | 0.00025488 | 0.00038243 | 0.00051904 | 0.0 | 0.01 +Neigh | 0.00033789 | 0.00036365 | 0.00040331 | 0.0 | 0.01 +Comm | 0.013439 | 0.021894 | 0.02956 | 2.9 | 0.34 +Output | 0.0038126 | 0.0038325 | 0.0040712 | 0.1 | 0.06 +Modify | 0.00021256 | 0.00028049 | 0.00035212 | 0.0 | 0.00 +Other | | 0.001189 | | | 0.02 Nlocal: 20.25 ave 26 max 12 min Histogram: 1 1 3 1 2 7 3 11 1 2 diff --git a/examples/amoeba/log.water_box.amoeba.32.test b/examples/amoeba/log.water_box.amoeba.32.test deleted file mode 100644 index 16a0168dac..0000000000 --- a/examples/amoeba/log.water_box.amoeba.32.test +++ /dev/null @@ -1,148 +0,0 @@ -LAMMPS (24 Mar 2022) -# water box with AMOEBA or HIPPO - -units real -boundary p p p - -atom_style amoeba -bond_style class2 -angle_style amoeba -dihedral_style none - -# per-atom properties required by AMOEBA or HIPPO - -fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom i_amgroup d_redID d_pval ghost yes -fix extra2 all property/atom i_polaxe d2_xyzaxis 3 - -# read data file - -read_data data.water_box.amoeba fix amtype NULL "Tinker Types" -Reading data file ... - orthogonal box = (0 0 0) to (18.643 18.643 18.643) - 2 by 4 by 4 MPI processor grid - reading atoms ... - 648 atoms - scanning bonds ... - 2 = max bonds/atom - scanning angles ... - 1 = max angles/atom - reading bonds ... - 432 bonds - reading angles ... - 216 angles -Finding 1-2 1-3 1-4 neighbors ... - special bond factors lj: 0 0 0 - special bond factors coul: 0 0 0 - 2 = max # of 1-2 neighbors - 1 = max # of 1-3 neighbors - 1 = max # of 1-4 neighbors - 2 = max # of special neighbors - special bonds CPU = 0.002 seconds - read_data CPU = 0.020 seconds - -# force field - -pair_style amoeba -pair_coeff * * amoeba_water.prm amoeba_water_box.key - -special_bonds lj/coul 0.5 0.5 0.5 one/five yes -Finding 1-2 1-3 1-4 neighbors ... - special bond factors lj: 0.5 0.5 0.5 - special bond factors coul: 0.5 0.5 0.5 - 2 = max # of 1-2 neighbors - 1 = max # of 1-3 neighbors - 1 = max # of 1-4 neighbors - 2 = max # of 1-5 neighbors - 2 = max # of special neighbors - special bonds CPU = 0.001 seconds - -# thermo output - -compute virial all pressure NULL virial - -thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] - -dump 1 all custom 10 dump.water_box id type x y z fx fy fz -dump_modify 1 sort id - -# zero step run - -#run 0 - -# dynamics - -fix 1 all nve - -thermo 10 -run 100 -AMOEBA/HIPPO force field settings - hal: cut 7 taper 6 vscale 0 0 1 1 - multipole: cut 7 aewald 0.4 bsorder 5 FFT 50 50 50 mscale 0 0 0.4 1 - polar: cut 7 aewald 0.5 bsorder 5 FFT 50 50 50 - pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 1 1 1 1 d/u scale 0 1 - precondition: cut 4.5 - generated 0 of 1 mixed pair_coeff terms from geometric mixing rule -Neighbor list info ... - update every 1 steps, delay 10 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 9 - ghost atom cutoff = 9 - binsize = 4.5, bins = 5 5 5 - 1 neighbor lists, perpetual/occasional/extra = 1 0 0 - (1) pair amoeba, perpetual - attributes: half, newton on - pair build: half/bin/newton - stencil: half/bin/3d - bin: standard - AMOEBA/HIPPO group count: 216 -Per MPI rank memory allocation (min/avg/max) = 57.47 | 57.48 | 57.74 Mbytes - Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] - 0 0 -2172.0441 166.82637 83.732524 0 0 250.5589 -1921.4852 -6181.7112 -4771.8292 -6955.3278 -6817.9765 -272.19746 3173.3487 2229.6526 - 10 105.50439 -2373.6865 136.67908 106.86552 0 0 243.54459 -1926.6678 -8441.2174 -10450.318 -9514.124 -9665.625 -301.45304 322.2435 1916.9694 - 20 143.90097 -2358.3516 70.951764 76.777106 0 0 147.72887 -1933.0976 -7370.463 -7728.4884 -11580.562 -8676.0017 -807.21546 780.4123 2096.7667 - 30 157.22768 -2375.4639 50.396281 87.108719 0 0 137.505 -1934.7321 -4449.9504 -6946.5881 -7865.3435 -4955.5443 -417.85139 -1004.0926 -36.630383 - 40 150.92709 -2354.1768 78.484257 53.799494 0 0 132.28375 -1930.8175 353.40845 -939.7978 -4636.1858 475.75837 -1074.4762 -1584.304 -574.27211 - 50 153.02614 -2388.7287 100.20124 65.814409 0 0 166.01565 -1927.5893 3975.1595 1366.008 426.2343 3887.1078 -1807.1658 -2534.8393 -2118.6912 - 60 155.01798 -2364.31 92.948309 44.252938 0 0 137.20125 -1928.1435 5793.7978 3521.2541 1421.9416 6110.7678 -1536.937 -2559.5674 -1502.2038 - 70 166.70629 -2383.4827 76.492455 55.020922 0 0 131.51338 -1930.4622 4743.9587 1916.6786 2839.9241 2670.7568 -169.67855 -187.58379 -2256.4529 - 80 171.82933 -2388.0347 76.463333 49.138785 0 0 125.60212 -1931.0453 2210.1222 -319.99043 330.98785 -394.25628 -44.858027 252.35533 -1985.0908 - 90 175.7327 -2423.7974 90.784969 63.725029 0 0 154.51 -1930.3722 -917.58179 -3941.9566 -2568.4278 -3415.3121 196.38051 2366.2885 -263.52434 - 100 173.73319 -2422.3616 99.761403 57.29505 0 0 157.05645 -1930.2461 -3586.4169 -5733.9943 -5881.4025 -6235.1905 -230.75166 959.02899 406.2349 -Loop time of 6.48935 on 32 procs for 100 steps with 648 atoms - -Performance: 1.331 ns/day, 18.026 hours/ns, 15.410 timesteps/s -99.8% CPU use with 32 MPI tasks x no OpenMP threads - -AMEOBA/HIPPO timing breakdown: - Init time: 0.0357484 0.00553355 - Hal time: 0.0364815 0.564704 - Mpole time: 0.541384 8.38018 - Induce time: 4.89091 75.7073 - Polar time: 0.955739 14.794 - Total time: 6.46029 - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 6.4536 | 6.4614 | 6.4698 | 0.2 | 99.57 -Bond | 0.00025488 | 0.00038243 | 0.00051904 | 0.0 | 0.01 -Neigh | 0.00033789 | 0.00036365 | 0.00040331 | 0.0 | 0.01 -Comm | 0.013439 | 0.021894 | 0.02956 | 2.9 | 0.34 -Output | 0.0038126 | 0.0038325 | 0.0040712 | 0.1 | 0.06 -Modify | 0.00021256 | 0.00028049 | 0.00035212 | 0.0 | 0.00 -Other | | 0.001189 | | | 0.02 - -Nlocal: 20.25 ave 26 max 12 min -Histogram: 1 1 3 1 2 7 3 11 1 2 -Nghost: 1381.97 ave 1413 max 1354 min -Histogram: 3 5 4 0 6 3 1 4 5 1 -Neighs: 3079.47 ave 4080 max 1858 min -Histogram: 1 3 1 2 5 6 7 5 0 2 - -Total # of neighbors = 98543 -Ave neighs/atom = 152.07253 -Ave special neighs/atom = 2 -Neighbor list builds = 2 -Dangerous builds = 0 -Total wall time: 0:00:06 diff --git a/examples/amoeba/log.water_box.hippo.1 b/examples/amoeba/log.water_box.hippo.1 index a49db65721..ffac98ae05 100644 --- a/examples/amoeba/log.water_box.hippo.1 +++ b/examples/amoeba/log.water_box.hippo.1 @@ -12,8 +12,8 @@ dihedral_style none # per-atom properties required by AMOEBA or HIPPO fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes -fix extra2 all property/atom i_polaxe +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 # read data file @@ -39,7 +39,7 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of special neighbors special bonds CPU = 0.000 seconds - read_data CPU = 0.010 seconds + read_data CPU = 0.012 seconds # force field @@ -98,7 +98,7 @@ Neighbor list info ... stencil: half/bin/3d bin: standard AMOEBA/HIPPO group count: 216 -Per MPI rank memory allocation (min/avg/max) = 10.89 | 10.89 | 10.89 Mbytes +Per MPI rank memory allocation (min/avg/max) = 57.8 | 57.8 | 57.8 Mbytes Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] 0 0 -2188.594 166.82637 77.478353 0 0 244.30473 -1944.2893 -10859.589 -9285.4645 -11598.049 -11695.254 -282.7072 3164.4148 2495.2578 10 100.94691 -2350.192 116.13156 88.56605 0 0 204.69761 -1950.8098 -11480.919 -13574.139 -12190.797 -12798.212 -263.77028 280.62864 1974.1486 @@ -110,33 +110,32 @@ Per MPI rank memory allocation (min/avg/max) = 10.89 | 10.89 | 10.89 Mbytes 70 184.86849 -2391.6106 39.916931 35.978152 0 0 75.895083 -1959.1811 -2146.9339 -4993.4021 -4095.6729 -4897.5768 -833.09046 1542.411 -1539.5266 80 164.75795 -2406.3017 101.94229 33.067832 0 0 135.01013 -1953.542 -8779.3265 -10545.409 -10418.702 -12098.858 -1319.194 1750.3511 -275.1272 90 151.17491 -2434.6876 152.21826 41.301673 0 0 193.51993 -1949.6141 -13330.691 -15436.505 -13791.461 -16934.674 149.25497 2289.1026 976.14333 - -AMEOBA/HIPPO timing info: - Init time: 0.0130348 0.00133126 - Repls time: 1.10221 11.257 - Disp time: 0.909199 9.28573 - Mpole time: 1.75286 17.9021 - Induce time: 3.46637 35.4024 - Polar time: 2.22081 22.6813 - Qxfer time: 0.326863 3.33828 - Total time: 9.79136 - 100 166.99163 -2452.5298 143.57768 35.341459 0 0 178.91914 -1951.5533 -14918.51 -16077.49 -17353.738 -18140.466 19.009088 1487.0469 1084.0231 -Loop time of 9.81706 on 1 procs for 100 steps with 648 atoms +Loop time of 9.27469 on 1 procs for 100 steps with 648 atoms -Performance: 0.880 ns/day, 27.270 hours/ns, 10.186 timesteps/s -98.8% CPU use with 1 MPI tasks x no OpenMP threads +Performance: 0.932 ns/day, 25.763 hours/ns, 10.782 timesteps/s +99.0% CPU use with 1 MPI tasks x no OpenMP threads + +AMEOBA/HIPPO timing breakdown: + Init time: 0.012403 0.00134127 + Repulse time: 1.04474 11.2979 + Disp time: 0.83125 8.98919 + Mpole time: 1.66803 18.0382 + Induce time: 3.2846 35.5199 + Polar time: 2.12371 22.9659 + Qxfer time: 0.282486 3.05482 + Total time: 9.24722 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 9.7915 | 9.7915 | 9.7915 | 0.0 | 99.74 -Bond | 0.0024566 | 0.0024566 | 0.0024566 | 0.0 | 0.03 -Neigh | 0.0056616 | 0.0056616 | 0.0056616 | 0.0 | 0.06 -Comm | 0.0022387 | 0.0022387 | 0.0022387 | 0.0 | 0.02 -Output | 0.013878 | 0.013878 | 0.013878 | 0.0 | 0.14 -Modify | 0.00062189 | 0.00062189 | 0.00062189 | 0.0 | 0.01 -Other | | 0.0007035 | | | 0.01 +Pair | 9.2473 | 9.2473 | 9.2473 | 0.0 | 99.70 +Bond | 0.0023727 | 0.0023727 | 0.0023727 | 0.0 | 0.03 +Neigh | 0.0055338 | 0.0055338 | 0.0055338 | 0.0 | 0.06 +Comm | 0.0021428 | 0.0021428 | 0.0021428 | 0.0 | 0.02 +Output | 0.016044 | 0.016044 | 0.016044 | 0.0 | 0.17 +Modify | 0.00059122 | 0.00059122 | 0.00059122 | 0.0 | 0.01 +Other | | 0.0006893 | | | 0.01 Nlocal: 648 ave 648 max 648 min Histogram: 1 0 0 0 0 0 0 0 0 0 @@ -150,4 +149,4 @@ Ave neighs/atom = 151.99074 Ave special neighs/atom = 2 Neighbor list builds = 2 Dangerous builds = 0 -Total wall time: 0:00:10 +Total wall time: 0:00:09 diff --git a/examples/amoeba/log.water_box.hippo.1.test b/examples/amoeba/log.water_box.hippo.1.test deleted file mode 100644 index ffac98ae05..0000000000 --- a/examples/amoeba/log.water_box.hippo.1.test +++ /dev/null @@ -1,152 +0,0 @@ -LAMMPS (24 Mar 2022) -# water box with AMOEBA or HIPPO - -units real -boundary p p p - -atom_style amoeba -bond_style class2 -angle_style amoeba -dihedral_style none - -# per-atom properties required by AMOEBA or HIPPO - -fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom i_amgroup d_redID d_pval ghost yes -fix extra2 all property/atom i_polaxe d2_xyzaxis 3 - -# read data file - -read_data data.water_box.hippo fix amtype NULL "Tinker Types" -Reading data file ... - orthogonal box = (0 0 0) to (18.643 18.643 18.643) - 1 by 1 by 1 MPI processor grid - reading atoms ... - 648 atoms - scanning bonds ... - 2 = max bonds/atom - scanning angles ... - 1 = max angles/atom - reading bonds ... - 432 bonds - reading angles ... - 216 angles -Finding 1-2 1-3 1-4 neighbors ... - special bond factors lj: 0 0 0 - special bond factors coul: 0 0 0 - 2 = max # of 1-2 neighbors - 1 = max # of 1-3 neighbors - 1 = max # of 1-4 neighbors - 2 = max # of special neighbors - special bonds CPU = 0.000 seconds - read_data CPU = 0.012 seconds - -# force field - -pair_style hippo -pair_coeff * * hippo_water.prm hippo_water_box.key - -special_bonds lj/coul 0.5 0.5 0.5 one/five yes -Finding 1-2 1-3 1-4 neighbors ... - special bond factors lj: 0.5 0.5 0.5 - special bond factors coul: 0.5 0.5 0.5 - 2 = max # of 1-2 neighbors - 1 = max # of 1-3 neighbors - 1 = max # of 1-4 neighbors - 2 = max # of 1-5 neighbors - 2 = max # of special neighbors - special bonds CPU = 0.001 seconds - -# thermo output - -compute virial all pressure NULL virial - -thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] - -dump 1 all custom 10 dump.water_box id type x y z fx fy fz -dump_modify 1 sort id - -# zero step run - -#run 0 - -# dynamics - -fix 1 all nve - -thermo 10 -run 100 -AMOEBA/HIPPO force field settings - repulsion: cut 7 taper 6 rscale 0 0 1 1 - qxfer: cut 7 taper 6 mscale 0 0 0.4 1 - dispersion: cut 7 aewald 0.45 bsorder 4 FFT 16 16 16 dspscale 0 0 0.4 1 - multipole: cut 7 aewald 0.4 bsorder 5 FFT 24 24 24 mscale 0 0 0.4 1 - polar: cut 7 aewald 0.5 bsorder 5 FFT 24 24 24 - pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 0.2 1 1 1 d/u scale 0 1 - precondition: cut 4.5 - generated 0 of 1 mixed pair_coeff terms from geometric mixing rule -Neighbor list info ... - update every 1 steps, delay 10 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 9 - ghost atom cutoff = 9 - binsize = 4.5, bins = 5 5 5 - 1 neighbor lists, perpetual/occasional/extra = 1 0 0 - (1) pair hippo, perpetual - attributes: half, newton on - pair build: half/bin/newton - stencil: half/bin/3d - bin: standard - AMOEBA/HIPPO group count: 216 -Per MPI rank memory allocation (min/avg/max) = 57.8 | 57.8 | 57.8 Mbytes - Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] - 0 0 -2188.594 166.82637 77.478353 0 0 244.30473 -1944.2893 -10859.589 -9285.4645 -11598.049 -11695.254 -282.7072 3164.4148 2495.2578 - 10 100.94691 -2350.192 116.13156 88.56605 0 0 204.69761 -1950.8098 -11480.919 -13574.139 -12190.797 -12798.212 -263.77028 280.62864 1974.1486 - 20 153.91622 -2358.3058 36.396961 66.22466 0 0 102.62162 -1958.8438 -7778.4529 -8492.3868 -11999.431 -9125.9998 -917.99962 589.09064 1788.2094 - 30 145.5951 -2343.9956 39.651541 65.833248 0 0 105.48479 -1957.7184 -288.79965 -2574.4466 -3820.4824 -414.28285 -347.51491 -1147.3995 -126.71025 - 40 126.87801 -2340.2623 102.93951 43.896946 0 0 146.83646 -1948.7309 6766.15 5908.7048 1280.0961 7930.8191 -1085.6811 -1596.6859 -714.82888 - 50 134.52078 -2358.9232 107.49288 44.253826 0 0 151.74671 -1947.7419 8762.4348 6023.4661 5377.0189 9396.0316 -1629.1364 -1663.1666 -2381.51 - 60 173.10181 -2374.3854 51.097314 33.03646 0 0 84.133774 -1956.4102 4614.2907 1719.1989 505.79149 4552.3167 -1661.1714 -587.92108 -1380.6732 - 70 184.86849 -2391.6106 39.916931 35.978152 0 0 75.895083 -1959.1811 -2146.9339 -4993.4021 -4095.6729 -4897.5768 -833.09046 1542.411 -1539.5266 - 80 164.75795 -2406.3017 101.94229 33.067832 0 0 135.01013 -1953.542 -8779.3265 -10545.409 -10418.702 -12098.858 -1319.194 1750.3511 -275.1272 - 90 151.17491 -2434.6876 152.21826 41.301673 0 0 193.51993 -1949.6141 -13330.691 -15436.505 -13791.461 -16934.674 149.25497 2289.1026 976.14333 - 100 166.99163 -2452.5298 143.57768 35.341459 0 0 178.91914 -1951.5533 -14918.51 -16077.49 -17353.738 -18140.466 19.009088 1487.0469 1084.0231 -Loop time of 9.27469 on 1 procs for 100 steps with 648 atoms - -Performance: 0.932 ns/day, 25.763 hours/ns, 10.782 timesteps/s -99.0% CPU use with 1 MPI tasks x no OpenMP threads - -AMEOBA/HIPPO timing breakdown: - Init time: 0.012403 0.00134127 - Repulse time: 1.04474 11.2979 - Disp time: 0.83125 8.98919 - Mpole time: 1.66803 18.0382 - Induce time: 3.2846 35.5199 - Polar time: 2.12371 22.9659 - Qxfer time: 0.282486 3.05482 - Total time: 9.24722 - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 9.2473 | 9.2473 | 9.2473 | 0.0 | 99.70 -Bond | 0.0023727 | 0.0023727 | 0.0023727 | 0.0 | 0.03 -Neigh | 0.0055338 | 0.0055338 | 0.0055338 | 0.0 | 0.06 -Comm | 0.0021428 | 0.0021428 | 0.0021428 | 0.0 | 0.02 -Output | 0.016044 | 0.016044 | 0.016044 | 0.0 | 0.17 -Modify | 0.00059122 | 0.00059122 | 0.00059122 | 0.0 | 0.01 -Other | | 0.0006893 | | | 0.01 - -Nlocal: 648 ave 648 max 648 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Nghost: 4282 ave 4282 max 4282 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Neighs: 98490 ave 98490 max 98490 min -Histogram: 1 0 0 0 0 0 0 0 0 0 - -Total # of neighbors = 98490 -Ave neighs/atom = 151.99074 -Ave special neighs/atom = 2 -Neighbor list builds = 2 -Dangerous builds = 0 -Total wall time: 0:00:09 diff --git a/examples/amoeba/log.water_box.hippo.32 b/examples/amoeba/log.water_box.hippo.32 index 7686b5fd25..5bf59135a6 100644 --- a/examples/amoeba/log.water_box.hippo.32 +++ b/examples/amoeba/log.water_box.hippo.32 @@ -12,8 +12,8 @@ dihedral_style none # per-atom properties required by AMOEBA or HIPPO fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes -fix extra2 all property/atom i_polaxe +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 # read data file @@ -39,7 +39,7 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of special neighbors special bonds CPU = 0.002 seconds - read_data CPU = 0.027 seconds + read_data CPU = 0.020 seconds # force field @@ -98,7 +98,7 @@ Neighbor list info ... stencil: half/bin/3d bin: standard AMOEBA/HIPPO group count: 216 -Per MPI rank memory allocation (min/avg/max) = 10.07 | 10.08 | 10.34 Mbytes +Per MPI rank memory allocation (min/avg/max) = 57.03 | 57.04 | 57.3 Mbytes Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] 0 0 -2188.594 166.82637 77.478353 0 0 244.30473 -1944.2893 -10859.589 -9285.4645 -11598.049 -11695.254 -282.7072 3164.4148 2495.2578 10 100.94691 -2350.192 116.13156 88.56605 0 0 204.69761 -1950.8098 -11480.919 -13574.139 -12190.797 -12798.212 -263.77028 280.62864 1974.1486 @@ -110,33 +110,32 @@ Per MPI rank memory allocation (min/avg/max) = 10.07 | 10.08 | 10.34 Mbytes 70 184.86849 -2391.6106 39.916931 35.978152 0 0 75.895083 -1959.1811 -2146.9339 -4993.4021 -4095.6729 -4897.5768 -833.09046 1542.411 -1539.5266 80 164.75795 -2406.3017 101.94229 33.067832 0 0 135.01013 -1953.542 -8779.3265 -10545.409 -10418.702 -12098.858 -1319.194 1750.3511 -275.1272 90 151.17491 -2434.6876 152.21826 41.301673 0 0 193.51993 -1949.6141 -13330.691 -15436.505 -13791.461 -16934.674 149.25497 2289.1026 976.14333 - -AMEOBA/HIPPO timing info: - Init time: 0.0225211 0.0138448 - Repls time: 0.0710727 4.36919 - Disp time: 0.147228 9.05085 - Mpole time: 0.271419 16.6855 - Induce time: 0.760323 46.7408 - Polar time: 0.341361 20.9851 - Qxfer time: 0.0127489 0.783737 - Total time: 1.62668 - 100 166.99163 -2452.5298 143.57768 35.341459 0 0 178.91914 -1951.5533 -14918.51 -16077.49 -17353.738 -18140.466 19.009088 1487.0469 1084.0231 -Loop time of 1.65072 on 32 procs for 100 steps with 648 atoms +Loop time of 1.60312 on 32 procs for 100 steps with 648 atoms -Performance: 5.234 ns/day, 4.585 hours/ns, 60.579 timesteps/s -99.7% CPU use with 32 MPI tasks x no OpenMP threads +Performance: 5.389 ns/day, 4.453 hours/ns, 62.378 timesteps/s +99.8% CPU use with 32 MPI tasks x no OpenMP threads + +AMEOBA/HIPPO timing breakdown: + Init time: 0.019742 0.012493 + Repulse time: 0.0675395 4.27399 + Disp time: 0.142632 9.02596 + Mpole time: 0.265051 16.7728 + Induce time: 0.740525 46.8614 + Polar time: 0.332551 21.0442 + Qxfer time: 0.0121995 0.772001 + Total time: 1.58025 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 1.6233 | 1.6277 | 1.632 | 0.2 | 98.61 -Bond | 0.0001841 | 0.00025145 | 0.00041274 | 0.0 | 0.02 -Neigh | 0.00046301 | 0.00052361 | 0.00059181 | 0.0 | 0.03 -Comm | 0.013032 | 0.017446 | 0.021961 | 1.7 | 1.06 -Output | 0.0035779 | 0.0036051 | 0.0038143 | 0.1 | 0.22 -Modify | 0.00011362 | 0.00018386 | 0.0002631 | 0.0 | 0.01 -Other | | 0.0009717 | | | 0.06 +Pair | 1.5773 | 1.5814 | 1.5855 | 0.2 | 98.65 +Bond | 0.00015755 | 0.00023663 | 0.0003199 | 0.0 | 0.01 +Neigh | 0.00036065 | 0.00038248 | 0.00042908 | 0.0 | 0.02 +Comm | 0.01209 | 0.016226 | 0.020477 | 1.7 | 1.01 +Output | 0.0037797 | 0.0038027 | 0.0040217 | 0.1 | 0.24 +Modify | 0.00010094 | 0.00013624 | 0.00018983 | 0.0 | 0.01 +Other | | 0.0008996 | | | 0.06 Nlocal: 20.25 ave 27 max 12 min Histogram: 1 1 3 1 6 2 10 4 2 2 diff --git a/examples/amoeba/log.water_box.hippo.32.test b/examples/amoeba/log.water_box.hippo.32.test deleted file mode 100644 index 5bf59135a6..0000000000 --- a/examples/amoeba/log.water_box.hippo.32.test +++ /dev/null @@ -1,152 +0,0 @@ -LAMMPS (24 Mar 2022) -# water box with AMOEBA or HIPPO - -units real -boundary p p p - -atom_style amoeba -bond_style class2 -angle_style amoeba -dihedral_style none - -# per-atom properties required by AMOEBA or HIPPO - -fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom i_amgroup d_redID d_pval ghost yes -fix extra2 all property/atom i_polaxe d2_xyzaxis 3 - -# read data file - -read_data data.water_box.hippo fix amtype NULL "Tinker Types" -Reading data file ... - orthogonal box = (0 0 0) to (18.643 18.643 18.643) - 2 by 4 by 4 MPI processor grid - reading atoms ... - 648 atoms - scanning bonds ... - 2 = max bonds/atom - scanning angles ... - 1 = max angles/atom - reading bonds ... - 432 bonds - reading angles ... - 216 angles -Finding 1-2 1-3 1-4 neighbors ... - special bond factors lj: 0 0 0 - special bond factors coul: 0 0 0 - 2 = max # of 1-2 neighbors - 1 = max # of 1-3 neighbors - 1 = max # of 1-4 neighbors - 2 = max # of special neighbors - special bonds CPU = 0.002 seconds - read_data CPU = 0.020 seconds - -# force field - -pair_style hippo -pair_coeff * * hippo_water.prm hippo_water_box.key - -special_bonds lj/coul 0.5 0.5 0.5 one/five yes -Finding 1-2 1-3 1-4 neighbors ... - special bond factors lj: 0.5 0.5 0.5 - special bond factors coul: 0.5 0.5 0.5 - 2 = max # of 1-2 neighbors - 1 = max # of 1-3 neighbors - 1 = max # of 1-4 neighbors - 2 = max # of 1-5 neighbors - 2 = max # of special neighbors - special bonds CPU = 0.002 seconds - -# thermo output - -compute virial all pressure NULL virial - -thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] - -dump 1 all custom 10 dump.water_box id type x y z fx fy fz -dump_modify 1 sort id - -# zero step run - -#run 0 - -# dynamics - -fix 1 all nve - -thermo 10 -run 100 -AMOEBA/HIPPO force field settings - repulsion: cut 7 taper 6 rscale 0 0 1 1 - qxfer: cut 7 taper 6 mscale 0 0 0.4 1 - dispersion: cut 7 aewald 0.45 bsorder 4 FFT 16 16 16 dspscale 0 0 0.4 1 - multipole: cut 7 aewald 0.4 bsorder 5 FFT 24 24 24 mscale 0 0 0.4 1 - polar: cut 7 aewald 0.5 bsorder 5 FFT 24 24 24 - pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 0.2 1 1 1 d/u scale 0 1 - precondition: cut 4.5 - generated 0 of 1 mixed pair_coeff terms from geometric mixing rule -Neighbor list info ... - update every 1 steps, delay 10 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 9 - ghost atom cutoff = 9 - binsize = 4.5, bins = 5 5 5 - 1 neighbor lists, perpetual/occasional/extra = 1 0 0 - (1) pair hippo, perpetual - attributes: half, newton on - pair build: half/bin/newton - stencil: half/bin/3d - bin: standard - AMOEBA/HIPPO group count: 216 -Per MPI rank memory allocation (min/avg/max) = 57.03 | 57.04 | 57.3 Mbytes - Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] - 0 0 -2188.594 166.82637 77.478353 0 0 244.30473 -1944.2893 -10859.589 -9285.4645 -11598.049 -11695.254 -282.7072 3164.4148 2495.2578 - 10 100.94691 -2350.192 116.13156 88.56605 0 0 204.69761 -1950.8098 -11480.919 -13574.139 -12190.797 -12798.212 -263.77028 280.62864 1974.1486 - 20 153.91622 -2358.3058 36.396961 66.22466 0 0 102.62162 -1958.8438 -7778.4529 -8492.3868 -11999.431 -9125.9998 -917.99962 589.09064 1788.2094 - 30 145.5951 -2343.9956 39.651541 65.833248 0 0 105.48479 -1957.7184 -288.79965 -2574.4466 -3820.4824 -414.28285 -347.51491 -1147.3995 -126.71025 - 40 126.87801 -2340.2623 102.93951 43.896946 0 0 146.83646 -1948.7309 6766.15 5908.7048 1280.0961 7930.8191 -1085.6811 -1596.6859 -714.82888 - 50 134.52078 -2358.9232 107.49288 44.253826 0 0 151.74671 -1947.7419 8762.4348 6023.4661 5377.0189 9396.0316 -1629.1364 -1663.1666 -2381.51 - 60 173.10181 -2374.3854 51.097314 33.03646 0 0 84.133774 -1956.4102 4614.2907 1719.1989 505.79149 4552.3167 -1661.1714 -587.92108 -1380.6732 - 70 184.86849 -2391.6106 39.916931 35.978152 0 0 75.895083 -1959.1811 -2146.9339 -4993.4021 -4095.6729 -4897.5768 -833.09046 1542.411 -1539.5266 - 80 164.75795 -2406.3017 101.94229 33.067832 0 0 135.01013 -1953.542 -8779.3265 -10545.409 -10418.702 -12098.858 -1319.194 1750.3511 -275.1272 - 90 151.17491 -2434.6876 152.21826 41.301673 0 0 193.51993 -1949.6141 -13330.691 -15436.505 -13791.461 -16934.674 149.25497 2289.1026 976.14333 - 100 166.99163 -2452.5298 143.57768 35.341459 0 0 178.91914 -1951.5533 -14918.51 -16077.49 -17353.738 -18140.466 19.009088 1487.0469 1084.0231 -Loop time of 1.60312 on 32 procs for 100 steps with 648 atoms - -Performance: 5.389 ns/day, 4.453 hours/ns, 62.378 timesteps/s -99.8% CPU use with 32 MPI tasks x no OpenMP threads - -AMEOBA/HIPPO timing breakdown: - Init time: 0.019742 0.012493 - Repulse time: 0.0675395 4.27399 - Disp time: 0.142632 9.02596 - Mpole time: 0.265051 16.7728 - Induce time: 0.740525 46.8614 - Polar time: 0.332551 21.0442 - Qxfer time: 0.0121995 0.772001 - Total time: 1.58025 - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 1.5773 | 1.5814 | 1.5855 | 0.2 | 98.65 -Bond | 0.00015755 | 0.00023663 | 0.0003199 | 0.0 | 0.01 -Neigh | 0.00036065 | 0.00038248 | 0.00042908 | 0.0 | 0.02 -Comm | 0.01209 | 0.016226 | 0.020477 | 1.7 | 1.01 -Output | 0.0037797 | 0.0038027 | 0.0040217 | 0.1 | 0.24 -Modify | 0.00010094 | 0.00013624 | 0.00018983 | 0.0 | 0.01 -Other | | 0.0008996 | | | 0.06 - -Nlocal: 20.25 ave 27 max 12 min -Histogram: 1 1 3 1 6 2 10 4 2 2 -Nghost: 1379.75 ave 1408 max 1345 min -Histogram: 2 4 1 3 3 4 4 3 2 6 -Neighs: 3077.81 ave 4233 max 1858 min -Histogram: 1 3 1 4 5 7 6 2 1 2 - -Total # of neighbors = 98490 -Ave neighs/atom = 151.99074 -Ave special neighs/atom = 2 -Neighbor list builds = 2 -Dangerous builds = 0 -Total wall time: 0:00:01 diff --git a/examples/amoeba/log.water_dimer.amoeba.1 b/examples/amoeba/log.water_dimer.amoeba.1 index 869e0c0eff..c982de2d9d 100644 --- a/examples/amoeba/log.water_dimer.amoeba.1 +++ b/examples/amoeba/log.water_dimer.amoeba.1 @@ -12,8 +12,8 @@ dihedral_style none # per-atom properties required by AMOEBA or HIPPO fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes -fix extra2 all property/atom i_polaxe +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 # read data file @@ -39,7 +39,7 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of special neighbors special bonds CPU = 0.000 seconds - read_data CPU = 0.007 seconds + read_data CPU = 0.008 seconds # force field @@ -97,7 +97,7 @@ Neighbor list info ... bin: standard WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (../domain.cpp:974) AMOEBA/HIPPO group count: 2 -Per MPI rank memory allocation (min/avg/max) = 9.855 | 9.855 | 9.855 Mbytes +Per MPI rank memory allocation (min/avg/max) = 49.59 | 49.59 | 49.59 Mbytes Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] 0 0 -5.1627563 0.025695395 0.71581114 0 0 0.74150653 -4.4212497 -12260.522 -43226.042 39448.214 -33003.739 -85.160886 -28101.905 -72.971988 10 1.1174766 -4.7928792 0.045080327 0.30848527 0 0 0.35356559 -4.4226587 -14728.416 11456.119 -52592.829 -3262.8454 70.868937 29494.268 57.977562 @@ -109,31 +109,30 @@ Per MPI rank memory allocation (min/avg/max) = 9.855 | 9.855 | 9.855 Mbytes 70 10.385926 -4.8250769 0.022572262 0.22235766 0 0 0.24492992 -4.4253547 -1117.3665 19070.918 -36063.612 11648.813 61.067533 25754.59 53.919881 80 12.797691 -5.123735 0.023756795 0.48275385 0 0 0.50651065 -4.4264869 -6491.9826 -28436.037 20681.908 -14176.121 -64.024669 -35737.052 -52.583533 90 12.569481 -4.8303379 0.060369422 0.15670502 0 0 0.21707444 -4.4259273 -16762.536 1720.5855 -47624.986 -6793.7441 59.966729 30024.566 52.339671 - -AMEOBA/HIPPO timing info: - Init time: 0.000126119 0.0205557 - Hal time: 0.000487693 7.94875 - Mpole time: 0.00066233 10.7951 - Induce time: 0.00328101 53.4761 - Polar time: 0.0015627 25.4699 - Total time: 0.00613547 - 100 17.750788 -5.1195235 0.039885925 0.38711474 0 0 0.42700067 -4.4279642 -10817.92 -21833.456 4186.8301 -18211.329 -43.11086 -32664.671 -41.508916 -Loop time of 0.00720187 on 1 procs for 100 steps with 6 atoms +Loop time of 0.00655818 on 1 procs for 100 steps with 6 atoms -Performance: 1199.688 ns/day, 0.020 hours/ns, 13885.283 timesteps/s -83.0% CPU use with 1 MPI tasks x no OpenMP threads +Performance: 1317.439 ns/day, 0.018 hours/ns, 15248.138 timesteps/s +98.5% CPU use with 1 MPI tasks x no OpenMP threads + +AMEOBA/HIPPO timing breakdown: + Init time: 0.000126483 0.0233682 + Hal time: 0.000471055 8.70292 + Mpole time: 0.000619314 11.4421 + Induce time: 0.00270856 50.0417 + Polar time: 0.00147122 27.1814 + Total time: 0.00541261 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.0062208 | 0.0062208 | 0.0062208 | 0.0 | 86.38 -Bond | 0.00010381 | 0.00010381 | 0.00010381 | 0.0 | 1.44 +Pair | 0.005443 | 0.005443 | 0.005443 | 0.0 | 83.00 +Bond | 9.6579e-05 | 9.6579e-05 | 9.6579e-05 | 0.0 | 1.47 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 1.4955e-05 | 1.4955e-05 | 1.4955e-05 | 0.0 | 0.21 -Output | 0.00075216 | 0.00075216 | 0.00075216 | 0.0 | 10.44 -Modify | 4.5409e-05 | 4.5409e-05 | 4.5409e-05 | 0.0 | 0.63 -Other | | 6.472e-05 | | | 0.90 +Comm | 1.7434e-05 | 1.7434e-05 | 1.7434e-05 | 0.0 | 0.27 +Output | 0.0008951 | 0.0008951 | 0.0008951 | 0.0 | 13.65 +Modify | 5.161e-05 | 5.161e-05 | 5.161e-05 | 0.0 | 0.79 +Other | | 5.444e-05 | | | 0.83 Nlocal: 6 ave 6 max 6 min Histogram: 1 0 0 0 0 0 0 0 0 0 diff --git a/examples/amoeba/log.water_dimer.amoeba.1.test b/examples/amoeba/log.water_dimer.amoeba.1.test deleted file mode 100644 index c982de2d9d..0000000000 --- a/examples/amoeba/log.water_dimer.amoeba.1.test +++ /dev/null @@ -1,149 +0,0 @@ -LAMMPS (24 Mar 2022) -# water dimer with AMOEBA or HIPPO - -units real -boundary s s s - -atom_style amoeba -bond_style class2 -angle_style amoeba -dihedral_style none - -# per-atom properties required by AMOEBA or HIPPO - -fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom i_amgroup d_redID d_pval ghost yes -fix extra2 all property/atom i_polaxe d2_xyzaxis 3 - -# read data file - -read_data data.water_dimer.amoeba fix amtype NULL "Tinker Types" -Reading data file ... - orthogonal box = (-1.463996 -0.756549 -0.009705) to (0.933234 0.75612 2.935934) - 1 by 1 by 1 MPI processor grid - reading atoms ... - 6 atoms - scanning bonds ... - 2 = max bonds/atom - scanning angles ... - 1 = max angles/atom - reading bonds ... - 4 bonds - reading angles ... - 2 angles -Finding 1-2 1-3 1-4 neighbors ... - special bond factors lj: 0 0 0 - special bond factors coul: 0 0 0 - 2 = max # of 1-2 neighbors - 1 = max # of 1-3 neighbors - 1 = max # of 1-4 neighbors - 2 = max # of special neighbors - special bonds CPU = 0.000 seconds - read_data CPU = 0.008 seconds - -# force field - -pair_style amoeba -pair_coeff * * amoeba_water.prm amoeba_water.key - -special_bonds lj/coul 0.5 0.5 0.5 one/five yes -Finding 1-2 1-3 1-4 neighbors ... - special bond factors lj: 0.5 0.5 0.5 - special bond factors coul: 0.5 0.5 0.5 - 2 = max # of 1-2 neighbors - 1 = max # of 1-3 neighbors - 1 = max # of 1-4 neighbors - 2 = max # of 1-5 neighbors - 2 = max # of special neighbors - special bonds CPU = 0.000 seconds - -# thermo output - -compute virial all pressure NULL virial - -thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] - -dump 1 all custom 10 dump.water_dimer id type x y z fx fy fz -dump_modify 1 sort id - -# zero step run - -#run 0 - -# dynamics - -fix 1 all nve - -thermo 10 -run 100 -AMOEBA/HIPPO force field settings - hal: cut 10 taper 8 vscale 0 0 1 1 - multipole: cut 10 aewald 0 mscale 0 0 0.4 1 - polar: cut 10 aewald 0 - pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 1 1 1 1 d/u scale 0 1 - precondition: cut 4.5 - generated 0 of 1 mixed pair_coeff terms from geometric mixing rule -Neighbor list info ... - update every 1 steps, delay 10 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 12 - ghost atom cutoff = 12 - binsize = 6, bins = 1 1 1 - 1 neighbor lists, perpetual/occasional/extra = 1 0 0 - (1) pair amoeba, perpetual - attributes: half, newton on - pair build: half/bin/newton - stencil: half/bin/3d - bin: standard -WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (../domain.cpp:974) - AMOEBA/HIPPO group count: 2 -Per MPI rank memory allocation (min/avg/max) = 49.59 | 49.59 | 49.59 Mbytes - Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] - 0 0 -5.1627563 0.025695395 0.71581114 0 0 0.74150653 -4.4212497 -12260.522 -43226.042 39448.214 -33003.739 -85.160886 -28101.905 -72.971988 - 10 1.1174766 -4.7928792 0.045080327 0.30848527 0 0 0.35356559 -4.4226587 -14728.416 11456.119 -52592.829 -3262.8454 70.868937 29494.268 57.977562 - 20 3.0821934 -5.1387316 0.013108182 0.65694692 0 0 0.6700551 -4.4227393 3007.4148 -25925.326 49641.41 -15284.933 -79.726771 -29005.234 -68.530079 - 30 3.461967 -4.8079248 0.013888863 0.31895667 0 0 0.33284554 -4.423482 8616.211 40027.877 -31134.295 16291.126 72.510013 23088.238 51.407946 - 40 4.2181367 -5.0535921 0.0099009766 0.55796811 0 0 0.56786908 -4.4228557 24239.885 -5761.6967 62095.735 15576.675 -76.240192 -33057.385 -58.850871 - 50 5.216657 -4.8012751 0.0053003148 0.29489399 0 0 0.30019431 -4.4233315 17728.056 44785.731 -21215.714 28613.715 66.24671 20292.137 51.010856 - 60 9.45101 -5.0818046 0.0043357361 0.5118733 0 0 0.51620903 -4.4247372 16893.135 -15068.961 50111.11 13824.77 -75.966047 -34809.168 -52.83183 - 70 10.385926 -4.8250769 0.022572262 0.22235766 0 0 0.24492992 -4.4253547 -1117.3665 19070.918 -36063.612 11648.813 61.067533 25754.59 53.919881 - 80 12.797691 -5.123735 0.023756795 0.48275385 0 0 0.50651065 -4.4264869 -6491.9826 -28436.037 20681.908 -14176.121 -64.024669 -35737.052 -52.583533 - 90 12.569481 -4.8303379 0.060369422 0.15670502 0 0 0.21707444 -4.4259273 -16762.536 1720.5855 -47624.986 -6793.7441 59.966729 30024.566 52.339671 - 100 17.750788 -5.1195235 0.039885925 0.38711474 0 0 0.42700067 -4.4279642 -10817.92 -21833.456 4186.8301 -18211.329 -43.11086 -32664.671 -41.508916 -Loop time of 0.00655818 on 1 procs for 100 steps with 6 atoms - -Performance: 1317.439 ns/day, 0.018 hours/ns, 15248.138 timesteps/s -98.5% CPU use with 1 MPI tasks x no OpenMP threads - -AMEOBA/HIPPO timing breakdown: - Init time: 0.000126483 0.0233682 - Hal time: 0.000471055 8.70292 - Mpole time: 0.000619314 11.4421 - Induce time: 0.00270856 50.0417 - Polar time: 0.00147122 27.1814 - Total time: 0.00541261 - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 0.005443 | 0.005443 | 0.005443 | 0.0 | 83.00 -Bond | 9.6579e-05 | 9.6579e-05 | 9.6579e-05 | 0.0 | 1.47 -Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 1.7434e-05 | 1.7434e-05 | 1.7434e-05 | 0.0 | 0.27 -Output | 0.0008951 | 0.0008951 | 0.0008951 | 0.0 | 13.65 -Modify | 5.161e-05 | 5.161e-05 | 5.161e-05 | 0.0 | 0.79 -Other | | 5.444e-05 | | | 0.83 - -Nlocal: 6 ave 6 max 6 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Nghost: 0 ave 0 max 0 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Neighs: 15 ave 15 max 15 min -Histogram: 1 0 0 0 0 0 0 0 0 0 - -Total # of neighbors = 15 -Ave neighs/atom = 2.5 -Ave special neighs/atom = 2 -Neighbor list builds = 0 -Dangerous builds = 0 -Total wall time: 0:00:00 diff --git a/examples/amoeba/log.water_dimer.amoeba.4 b/examples/amoeba/log.water_dimer.amoeba.4 index e5396339d9..026fcfdbcc 100644 --- a/examples/amoeba/log.water_dimer.amoeba.4 +++ b/examples/amoeba/log.water_dimer.amoeba.4 @@ -12,8 +12,8 @@ dihedral_style none # per-atom properties required by AMOEBA or HIPPO fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes -fix extra2 all property/atom i_polaxe +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 # read data file @@ -55,7 +55,7 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of 1-5 neighbors 2 = max # of special neighbors - special bonds CPU = 0.001 seconds + special bonds CPU = 0.000 seconds # thermo output @@ -97,7 +97,7 @@ Neighbor list info ... bin: standard WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (../domain.cpp:974) AMOEBA/HIPPO group count: 2 -Per MPI rank memory allocation (min/avg/max) = 9.883 | 10.02 | 10.15 Mbytes +Per MPI rank memory allocation (min/avg/max) = 49.61 | 49.75 | 49.88 Mbytes Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] 0 0 -5.1627563 0.025695395 0.71581114 0 0 0.74150653 -4.4212497 -12260.522 -43226.042 39448.214 -33003.739 -85.160886 -28101.905 -72.971988 10 1.1174766 -4.7928792 0.045080327 0.30848527 0 0 0.35356559 -4.4226587 -14728.416 11456.119 -52592.829 -3262.8454 70.868937 29494.268 57.977562 @@ -109,31 +109,30 @@ Per MPI rank memory allocation (min/avg/max) = 9.883 | 10.02 | 10.15 Mbytes 70 10.385926 -4.8250769 0.022572262 0.22235766 0 0 0.24492992 -4.4253547 -1117.3665 19070.918 -36063.612 11648.813 61.067533 25754.59 53.919881 80 12.797691 -5.123735 0.023756795 0.48275385 0 0 0.50651065 -4.4264869 -6491.9826 -28436.037 20681.908 -14176.121 -64.024669 -35737.052 -52.583533 90 12.569481 -4.8303379 0.060369422 0.15670502 0 0 0.21707444 -4.4259273 -16762.536 1720.5855 -47624.986 -6793.7441 59.966729 30024.566 52.339671 - -AMEOBA/HIPPO timing info: - Init time: 0.000562834 0.0392455 - Hal time: 0.000119032 0.829992 - Mpole time: 0.000759989 5.29928 - Induce time: 0.0118027 82.2984 - Polar time: 0.00108262 7.54891 - Total time: 0.0143414 - 100 17.750788 -5.1195235 0.039885925 0.38711474 0 0 0.42700067 -4.4279642 -10817.92 -21833.456 4186.8301 -18211.329 -43.11086 -32664.671 -41.508916 -Loop time of 0.0169266 on 4 procs for 100 steps with 6 atoms +Loop time of 0.0167554 on 4 procs for 100 steps with 6 atoms -Performance: 510.439 ns/day, 0.047 hours/ns, 5907.863 timesteps/s -99.7% CPU use with 4 MPI tasks x no OpenMP threads +Performance: 515.654 ns/day, 0.047 hours/ns, 5968.213 timesteps/s +99.4% CPU use with 4 MPI tasks x no OpenMP threads + +AMEOBA/HIPPO timing breakdown: + Init time: 0.000555846 0.0390251 + Hal time: 0.000129733 0.910835 + Mpole time: 0.000783914 5.50375 + Induce time: 0.0115771 81.2811 + Polar time: 0.00118294 8.30522 + Total time: 0.0142433 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.014229 | 0.01457 | 0.014803 | 0.2 | 86.08 -Bond | 1.311e-05 | 4.1295e-05 | 6.8411e-05 | 0.0 | 0.24 +Pair | 0.013911 | 0.014439 | 0.0147 | 0.3 | 86.18 +Bond | 1.196e-05 | 4.4667e-05 | 8.5848e-05 | 0.0 | 0.27 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.00067827 | 0.0008315 | 0.0011965 | 0.0 | 4.91 -Output | 0.00094515 | 0.0010124 | 0.0011247 | 0.2 | 5.98 -Modify | 2.1384e-05 | 4.0305e-05 | 5.4006e-05 | 0.0 | 0.24 -Other | | 0.0004309 | | | 2.55 +Comm | 0.00060682 | 0.00082002 | 0.001342 | 0.0 | 4.89 +Output | 0.00098235 | 0.0010281 | 0.0011458 | 0.2 | 6.14 +Modify | 2.2946e-05 | 3.473e-05 | 4.2983e-05 | 0.0 | 0.21 +Other | | 0.0003885 | | | 2.32 Nlocal: 1.5 ave 3 max 0 min Histogram: 2 0 0 0 0 0 0 0 0 2 diff --git a/examples/amoeba/log.water_dimer.amoeba.4.test b/examples/amoeba/log.water_dimer.amoeba.4.test deleted file mode 100644 index 026fcfdbcc..0000000000 --- a/examples/amoeba/log.water_dimer.amoeba.4.test +++ /dev/null @@ -1,149 +0,0 @@ -LAMMPS (24 Mar 2022) -# water dimer with AMOEBA or HIPPO - -units real -boundary s s s - -atom_style amoeba -bond_style class2 -angle_style amoeba -dihedral_style none - -# per-atom properties required by AMOEBA or HIPPO - -fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom i_amgroup d_redID d_pval ghost yes -fix extra2 all property/atom i_polaxe d2_xyzaxis 3 - -# read data file - -read_data data.water_dimer.amoeba fix amtype NULL "Tinker Types" -Reading data file ... - orthogonal box = (-1.463996 -0.756549 -0.009705) to (0.933234 0.75612 2.935934) - 2 by 1 by 2 MPI processor grid - reading atoms ... - 6 atoms - scanning bonds ... - 2 = max bonds/atom - scanning angles ... - 1 = max angles/atom - reading bonds ... - 4 bonds - reading angles ... - 2 angles -Finding 1-2 1-3 1-4 neighbors ... - special bond factors lj: 0 0 0 - special bond factors coul: 0 0 0 - 2 = max # of 1-2 neighbors - 1 = max # of 1-3 neighbors - 1 = max # of 1-4 neighbors - 2 = max # of special neighbors - special bonds CPU = 0.000 seconds - read_data CPU = 0.009 seconds - -# force field - -pair_style amoeba -pair_coeff * * amoeba_water.prm amoeba_water.key - -special_bonds lj/coul 0.5 0.5 0.5 one/five yes -Finding 1-2 1-3 1-4 neighbors ... - special bond factors lj: 0.5 0.5 0.5 - special bond factors coul: 0.5 0.5 0.5 - 2 = max # of 1-2 neighbors - 1 = max # of 1-3 neighbors - 1 = max # of 1-4 neighbors - 2 = max # of 1-5 neighbors - 2 = max # of special neighbors - special bonds CPU = 0.000 seconds - -# thermo output - -compute virial all pressure NULL virial - -thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] - -dump 1 all custom 10 dump.water_dimer id type x y z fx fy fz -dump_modify 1 sort id - -# zero step run - -#run 0 - -# dynamics - -fix 1 all nve - -thermo 10 -run 100 -AMOEBA/HIPPO force field settings - hal: cut 10 taper 8 vscale 0 0 1 1 - multipole: cut 10 aewald 0 mscale 0 0 0.4 1 - polar: cut 10 aewald 0 - pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 1 1 1 1 d/u scale 0 1 - precondition: cut 4.5 - generated 0 of 1 mixed pair_coeff terms from geometric mixing rule -Neighbor list info ... - update every 1 steps, delay 10 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 12 - ghost atom cutoff = 12 - binsize = 6, bins = 1 1 1 - 1 neighbor lists, perpetual/occasional/extra = 1 0 0 - (1) pair amoeba, perpetual - attributes: half, newton on - pair build: half/bin/newton - stencil: half/bin/3d - bin: standard -WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (../domain.cpp:974) - AMOEBA/HIPPO group count: 2 -Per MPI rank memory allocation (min/avg/max) = 49.61 | 49.75 | 49.88 Mbytes - Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] - 0 0 -5.1627563 0.025695395 0.71581114 0 0 0.74150653 -4.4212497 -12260.522 -43226.042 39448.214 -33003.739 -85.160886 -28101.905 -72.971988 - 10 1.1174766 -4.7928792 0.045080327 0.30848527 0 0 0.35356559 -4.4226587 -14728.416 11456.119 -52592.829 -3262.8454 70.868937 29494.268 57.977562 - 20 3.0821934 -5.1387316 0.013108182 0.65694692 0 0 0.6700551 -4.4227393 3007.4148 -25925.326 49641.41 -15284.933 -79.726771 -29005.234 -68.530079 - 30 3.461967 -4.8079248 0.013888863 0.31895667 0 0 0.33284554 -4.423482 8616.211 40027.877 -31134.295 16291.126 72.510013 23088.238 51.407946 - 40 4.2181367 -5.0535921 0.0099009766 0.55796811 0 0 0.56786908 -4.4228557 24239.885 -5761.6967 62095.735 15576.675 -76.240192 -33057.385 -58.850871 - 50 5.216657 -4.8012751 0.0053003148 0.29489399 0 0 0.30019431 -4.4233315 17728.056 44785.731 -21215.714 28613.715 66.24671 20292.137 51.010856 - 60 9.45101 -5.0818046 0.0043357361 0.5118733 0 0 0.51620903 -4.4247372 16893.135 -15068.961 50111.11 13824.77 -75.966047 -34809.168 -52.83183 - 70 10.385926 -4.8250769 0.022572262 0.22235766 0 0 0.24492992 -4.4253547 -1117.3665 19070.918 -36063.612 11648.813 61.067533 25754.59 53.919881 - 80 12.797691 -5.123735 0.023756795 0.48275385 0 0 0.50651065 -4.4264869 -6491.9826 -28436.037 20681.908 -14176.121 -64.024669 -35737.052 -52.583533 - 90 12.569481 -4.8303379 0.060369422 0.15670502 0 0 0.21707444 -4.4259273 -16762.536 1720.5855 -47624.986 -6793.7441 59.966729 30024.566 52.339671 - 100 17.750788 -5.1195235 0.039885925 0.38711474 0 0 0.42700067 -4.4279642 -10817.92 -21833.456 4186.8301 -18211.329 -43.11086 -32664.671 -41.508916 -Loop time of 0.0167554 on 4 procs for 100 steps with 6 atoms - -Performance: 515.654 ns/day, 0.047 hours/ns, 5968.213 timesteps/s -99.4% CPU use with 4 MPI tasks x no OpenMP threads - -AMEOBA/HIPPO timing breakdown: - Init time: 0.000555846 0.0390251 - Hal time: 0.000129733 0.910835 - Mpole time: 0.000783914 5.50375 - Induce time: 0.0115771 81.2811 - Polar time: 0.00118294 8.30522 - Total time: 0.0142433 - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 0.013911 | 0.014439 | 0.0147 | 0.3 | 86.18 -Bond | 1.196e-05 | 4.4667e-05 | 8.5848e-05 | 0.0 | 0.27 -Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.00060682 | 0.00082002 | 0.001342 | 0.0 | 4.89 -Output | 0.00098235 | 0.0010281 | 0.0011458 | 0.2 | 6.14 -Modify | 2.2946e-05 | 3.473e-05 | 4.2983e-05 | 0.0 | 0.21 -Other | | 0.0003885 | | | 2.32 - -Nlocal: 1.5 ave 3 max 0 min -Histogram: 2 0 0 0 0 0 0 0 0 2 -Nghost: 4.5 ave 6 max 3 min -Histogram: 2 0 0 0 0 0 0 0 0 2 -Neighs: 3.75 ave 12 max 0 min -Histogram: 2 0 1 0 0 0 0 0 0 1 - -Total # of neighbors = 15 -Ave neighs/atom = 2.5 -Ave special neighs/atom = 2 -Neighbor list builds = 0 -Dangerous builds = 0 -Total wall time: 0:00:00 diff --git a/examples/amoeba/log.water_dimer.hippo.1 b/examples/amoeba/log.water_dimer.hippo.1 index 313c462c72..7ec0d856e7 100644 --- a/examples/amoeba/log.water_dimer.hippo.1 +++ b/examples/amoeba/log.water_dimer.hippo.1 @@ -12,8 +12,8 @@ dihedral_style none # per-atom properties required by AMOEBA or HIPPO fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes -fix extra2 all property/atom i_polaxe +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 # read data file @@ -39,7 +39,7 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of special neighbors special bonds CPU = 0.000 seconds - read_data CPU = 0.007 seconds + read_data CPU = 0.008 seconds # force field @@ -99,7 +99,7 @@ Neighbor list info ... bin: standard WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (../domain.cpp:974) AMOEBA/HIPPO group count: 2 -Per MPI rank memory allocation (min/avg/max) = 9.855 | 9.855 | 9.855 Mbytes +Per MPI rank memory allocation (min/avg/max) = 49.15 | 49.15 | 49.15 Mbytes Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] 0 0 -5.0101954 0.025695395 0.51472748 0 0 0.54042288 -4.4697726 -11875.159 -38149.178 29162.678 -26638.977 -70.63422 -24614.614 -58.505595 10 0.75132894 -4.7952077 0.028216017 0.28494196 0 0 0.31315798 -4.4708519 -13243.822 12661.254 -49613.657 -2923.1497 69.449413 29456.684 56.087663 @@ -111,33 +111,32 @@ Per MPI rank memory allocation (min/avg/max) = 9.855 | 9.855 | 9.855 Mbytes 70 5.3145827 -4.8748857 0.025797484 0.29875503 0 0 0.32455252 -4.4711244 -10208.876 26324.134 -49272.688 -8697.2875 84.479942 36185.667 57.000355 80 3.8409793 -5.0262066 0.027669388 0.47104466 0 0 0.49871405 -4.4702464 -9777.1809 -52088.554 28053.855 -6033.4555 -94.607853 -44638.417 -59.108505 90 3.0683704 -4.8369716 0.035455716 0.28466932 0 0 0.32012503 -4.4711155 -10626.245 31066.635 -49425.925 -14107.889 87.765958 34632.905 52.101981 - -AMEOBA/HIPPO timing info: - Init time: 0.000114914 0.0215289 - Repls time: 0.000617533 11.5693 - Disp time: 0.000365952 6.85603 - Mpole time: 0.000944495 17.6949 - Induce time: 0.00199722 37.4176 - Polar time: 0.0011473 21.4944 - Qxfer time: 0.000145366 2.7234 - Total time: 0.00533767 - 100 3.5262799 -4.9906817 0.016687539 0.45011301 0 0 0.46680055 -4.4713252 5216.7691 -34991.221 43883.163 6082.1058 -95.830393 -48645.129 -64.784334 -Loop time of 0.0063791 on 1 procs for 100 steps with 6 atoms +Loop time of 0.00568827 on 1 procs for 100 steps with 6 atoms -Performance: 1354.423 ns/day, 0.018 hours/ns, 15676.190 timesteps/s -98.9% CPU use with 1 MPI tasks x no OpenMP threads +Performance: 1518.916 ns/day, 0.016 hours/ns, 17580.041 timesteps/s +76.9% CPU use with 1 MPI tasks x no OpenMP threads + +AMEOBA/HIPPO timing breakdown: + Init time: 0.00011293 0.024348 + Repulse time: 0.000604058 13.0236 + Disp time: 0.000336908 7.26382 + Mpole time: 0.000853828 18.4087 + Induce time: 0.00158723 34.2211 + Polar time: 0.000996193 21.4782 + Qxfer time: 0.000142246 3.06686 + Total time: 0.00463817 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.005435 | 0.005435 | 0.005435 | 0.0 | 85.20 -Bond | 8.7439e-05 | 8.7439e-05 | 8.7439e-05 | 0.0 | 1.37 +Pair | 0.0046663 | 0.0046663 | 0.0046663 | 0.0 | 82.03 +Bond | 7.8168e-05 | 7.8168e-05 | 7.8168e-05 | 0.0 | 1.37 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 1.447e-05 | 1.447e-05 | 1.447e-05 | 0.0 | 0.23 -Output | 0.00073302 | 0.00073302 | 0.00073302 | 0.0 | 11.49 -Modify | 4.6662e-05 | 4.6662e-05 | 4.6662e-05 | 0.0 | 0.73 -Other | | 6.248e-05 | | | 0.98 +Comm | 1.3206e-05 | 1.3206e-05 | 1.3206e-05 | 0.0 | 0.23 +Output | 0.00084402 | 0.00084402 | 0.00084402 | 0.0 | 14.84 +Modify | 3.8896e-05 | 3.8896e-05 | 3.8896e-05 | 0.0 | 0.68 +Other | | 4.77e-05 | | | 0.84 Nlocal: 6 ave 6 max 6 min Histogram: 1 0 0 0 0 0 0 0 0 0 diff --git a/examples/amoeba/log.water_dimer.hippo.1.test b/examples/amoeba/log.water_dimer.hippo.1.test deleted file mode 100644 index 7ec0d856e7..0000000000 --- a/examples/amoeba/log.water_dimer.hippo.1.test +++ /dev/null @@ -1,153 +0,0 @@ -LAMMPS (24 Mar 2022) -# water dimer with AMOEBA or HIPPO - -units real -boundary s s s - -atom_style amoeba -bond_style class2 -angle_style amoeba -dihedral_style none - -# per-atom properties required by AMOEBA or HIPPO - -fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom i_amgroup d_redID d_pval ghost yes -fix extra2 all property/atom i_polaxe d2_xyzaxis 3 - -# read data file - -read_data data.water_dimer.hippo fix amtype NULL "Tinker Types" -Reading data file ... - orthogonal box = (-1.463996 -0.756549 -0.009705) to (0.933234 0.75612 2.935934) - 1 by 1 by 1 MPI processor grid - reading atoms ... - 6 atoms - scanning bonds ... - 2 = max bonds/atom - scanning angles ... - 1 = max angles/atom - reading bonds ... - 4 bonds - reading angles ... - 2 angles -Finding 1-2 1-3 1-4 neighbors ... - special bond factors lj: 0 0 0 - special bond factors coul: 0 0 0 - 2 = max # of 1-2 neighbors - 1 = max # of 1-3 neighbors - 1 = max # of 1-4 neighbors - 2 = max # of special neighbors - special bonds CPU = 0.000 seconds - read_data CPU = 0.008 seconds - -# force field - -pair_style hippo -pair_coeff * * hippo_water.prm hippo_water.key - -special_bonds lj/coul 0.5 0.5 0.5 one/five yes -Finding 1-2 1-3 1-4 neighbors ... - special bond factors lj: 0.5 0.5 0.5 - special bond factors coul: 0.5 0.5 0.5 - 2 = max # of 1-2 neighbors - 1 = max # of 1-3 neighbors - 1 = max # of 1-4 neighbors - 2 = max # of 1-5 neighbors - 2 = max # of special neighbors - special bonds CPU = 0.000 seconds - -# thermo output - -compute virial all pressure NULL virial - -thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] - -dump 1 all custom 10 dump.water_dimer id type x y z fx fy fz -dump_modify 1 sort id - -# zero step run - -#run 0 - -# dynamics - -fix 1 all nve - -thermo 10 -run 100 -AMOEBA/HIPPO force field settings - repulsion: cut 10 taper 8 rscale 0 0 1 1 - qxfer: cut 10 taper 8 mscale 0 0 0.4 1 - dispersion: cut 10 aewald 0 dspscale 0 0 0.4 1 - multipole: cut 10 aewald 0 mscale 0 0 0.4 1 - polar: cut 10 aewald 0 - pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 0.2 1 1 1 d/u scale 0 1 - precondition: cut 4.5 - generated 0 of 1 mixed pair_coeff terms from geometric mixing rule -Neighbor list info ... - update every 1 steps, delay 10 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 12 - ghost atom cutoff = 12 - binsize = 6, bins = 1 1 1 - 1 neighbor lists, perpetual/occasional/extra = 1 0 0 - (1) pair hippo, perpetual - attributes: half, newton on - pair build: half/bin/newton - stencil: half/bin/3d - bin: standard -WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (../domain.cpp:974) - AMOEBA/HIPPO group count: 2 -Per MPI rank memory allocation (min/avg/max) = 49.15 | 49.15 | 49.15 Mbytes - Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] - 0 0 -5.0101954 0.025695395 0.51472748 0 0 0.54042288 -4.4697726 -11875.159 -38149.178 29162.678 -26638.977 -70.63422 -24614.614 -58.505595 - 10 0.75132894 -4.7952077 0.028216017 0.28494196 0 0 0.31315798 -4.4708519 -13243.822 12661.254 -49613.657 -2923.1497 69.449413 29456.684 56.087663 - 20 2.1716525 -5.0036265 0.011809223 0.48875837 0 0 0.50056759 -4.4706925 4371.5298 -22102.532 47044.297 -12243.648 -74.588915 -28903.762 -64.48154 - 30 2.9930198 -4.8261906 0.0091463366 0.30162756 0 0 0.3107739 -4.4708086 9992.4549 41973.539 -20985.339 8415.1715 67.458145 25027.414 40.261795 - 40 3.312268 -4.9802484 0.010400667 0.45076258 0 0 0.46116325 -4.4697189 21565.307 -11602.414 65186.215 10476.902 -83.374203 -33222.094 -64.700001 - 50 4.3187397 -4.8535614 0.0060313545 0.31244652 0 0 0.31847788 -4.4707168 11344.244 45839.35 -21073.749 8438.8954 73.345039 29422.636 43.897876 - 60 4.9127902 -5.0035271 0.0070589202 0.45246538 0 0 0.4595243 -4.4707824 6529.9354 -37107.891 46740.24 9015.2973 -90.41111 -34402.095 -53.57079 - 70 5.3145827 -4.8748857 0.025797484 0.29875503 0 0 0.32455252 -4.4711244 -10208.876 26324.134 -49272.688 -8697.2875 84.479942 36185.667 57.000355 - 80 3.8409793 -5.0262066 0.027669388 0.47104466 0 0 0.49871405 -4.4702464 -9777.1809 -52088.554 28053.855 -6033.4555 -94.607853 -44638.417 -59.108505 - 90 3.0683704 -4.8369716 0.035455716 0.28466932 0 0 0.32012503 -4.4711155 -10626.245 31066.635 -49425.925 -14107.889 87.765958 34632.905 52.101981 - 100 3.5262799 -4.9906817 0.016687539 0.45011301 0 0 0.46680055 -4.4713252 5216.7691 -34991.221 43883.163 6082.1058 -95.830393 -48645.129 -64.784334 -Loop time of 0.00568827 on 1 procs for 100 steps with 6 atoms - -Performance: 1518.916 ns/day, 0.016 hours/ns, 17580.041 timesteps/s -76.9% CPU use with 1 MPI tasks x no OpenMP threads - -AMEOBA/HIPPO timing breakdown: - Init time: 0.00011293 0.024348 - Repulse time: 0.000604058 13.0236 - Disp time: 0.000336908 7.26382 - Mpole time: 0.000853828 18.4087 - Induce time: 0.00158723 34.2211 - Polar time: 0.000996193 21.4782 - Qxfer time: 0.000142246 3.06686 - Total time: 0.00463817 - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 0.0046663 | 0.0046663 | 0.0046663 | 0.0 | 82.03 -Bond | 7.8168e-05 | 7.8168e-05 | 7.8168e-05 | 0.0 | 1.37 -Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 1.3206e-05 | 1.3206e-05 | 1.3206e-05 | 0.0 | 0.23 -Output | 0.00084402 | 0.00084402 | 0.00084402 | 0.0 | 14.84 -Modify | 3.8896e-05 | 3.8896e-05 | 3.8896e-05 | 0.0 | 0.68 -Other | | 4.77e-05 | | | 0.84 - -Nlocal: 6 ave 6 max 6 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Nghost: 0 ave 0 max 0 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Neighs: 15 ave 15 max 15 min -Histogram: 1 0 0 0 0 0 0 0 0 0 - -Total # of neighbors = 15 -Ave neighs/atom = 2.5 -Ave special neighs/atom = 2 -Neighbor list builds = 0 -Dangerous builds = 0 -Total wall time: 0:00:00 diff --git a/examples/amoeba/log.water_dimer.hippo.4 b/examples/amoeba/log.water_dimer.hippo.4 index a56de55964..cd0767ae54 100644 --- a/examples/amoeba/log.water_dimer.hippo.4 +++ b/examples/amoeba/log.water_dimer.hippo.4 @@ -12,8 +12,8 @@ dihedral_style none # per-atom properties required by AMOEBA or HIPPO fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes -fix extra2 all property/atom i_polaxe +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 # read data file @@ -99,7 +99,7 @@ Neighbor list info ... bin: standard WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (../domain.cpp:974) AMOEBA/HIPPO group count: 2 -Per MPI rank memory allocation (min/avg/max) = 9.883 | 10.02 | 10.15 Mbytes +Per MPI rank memory allocation (min/avg/max) = 49.18 | 49.31 | 49.44 Mbytes Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] 0 0 -5.0101954 0.025695395 0.51472748 0 0 0.54042288 -4.4697726 -11875.159 -38149.178 29162.678 -26638.977 -70.63422 -24614.614 -58.505595 10 0.75132894 -4.7952077 0.028216017 0.28494196 0 0 0.31315798 -4.4708519 -13243.822 12661.254 -49613.657 -2923.1497 69.449413 29456.684 56.087663 @@ -111,33 +111,32 @@ Per MPI rank memory allocation (min/avg/max) = 9.883 | 10.02 | 10.15 Mbytes 70 5.3145827 -4.8748857 0.025797484 0.29875503 0 0 0.32455252 -4.4711244 -10208.876 26324.134 -49272.688 -8697.2875 84.479942 36185.667 57.000355 80 3.8409793 -5.0262066 0.027669388 0.47104466 0 0 0.49871405 -4.4702464 -9777.1809 -52088.554 28053.855 -6033.4555 -94.607853 -44638.417 -59.108505 90 3.0683704 -4.8369716 0.035455716 0.28466932 0 0 0.32012503 -4.4711155 -10626.245 31066.635 -49425.925 -14107.889 87.765958 34632.905 52.101981 - -AMEOBA/HIPPO timing info: - Init time: 0.000628997 0.0480375 - Repls time: 0.000859377 6.5632 - Disp time: 0.00015718 1.20041 - Mpole time: 0.00153385 11.7143 - Induce time: 0.0085554 65.339 - Polar time: 0.00127985 9.77439 - Qxfer time: 7.40915e-05 0.565849 - Total time: 0.0130939 - 100 3.5262799 -4.9906817 0.016687539 0.45011301 0 0 0.46680055 -4.4713252 5216.7691 -34991.221 43883.163 6082.1058 -95.830393 -48645.129 -64.784334 -Loop time of 0.0163786 on 4 procs for 100 steps with 6 atoms +Loop time of 0.0133873 on 4 procs for 100 steps with 6 atoms -Performance: 527.519 ns/day, 0.045 hours/ns, 6105.545 timesteps/s -98.7% CPU use with 4 MPI tasks x no OpenMP threads +Performance: 645.386 ns/day, 0.037 hours/ns, 7469.744 timesteps/s +98.4% CPU use with 4 MPI tasks x no OpenMP threads + +AMEOBA/HIPPO timing breakdown: + Init time: 0.000581606 0.0545512 + Repulse time: 0.000622984 5.84322 + Disp time: 0.000115637 1.0846 + Mpole time: 0.000994723 9.32991 + Induce time: 0.00737161 69.1413 + Polar time: 0.00091816 8.61179 + Qxfer time: 5.1997e-05 0.487701 + Total time: 0.0106617 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.012747 | 0.013356 | 0.013763 | 0.3 | 81.55 -Bond | 1.4562e-05 | 5.3301e-05 | 0.00010757 | 0.0 | 0.33 +Pair | 0.010579 | 0.010896 | 0.011085 | 0.2 | 81.39 +Bond | 1.3578e-05 | 4.3855e-05 | 7.6592e-05 | 0.0 | 0.33 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.00061214 | 0.001076 | 0.0015518 | 1.0 | 6.57 -Output | 0.0011991 | 0.0013282 | 0.0015124 | 0.3 | 8.11 -Modify | 2.2511e-05 | 3.8778e-05 | 5.1854e-05 | 0.0 | 0.24 -Other | | 0.0005259 | | | 3.21 +Comm | 0.00058533 | 0.00080957 | 0.0011064 | 0.0 | 6.05 +Output | 0.0011175 | 0.0011761 | 0.0013051 | 0.2 | 8.78 +Modify | 2.4304e-05 | 3.4805e-05 | 4.2149e-05 | 0.0 | 0.26 +Other | | 0.0004266 | | | 3.19 Nlocal: 1.5 ave 3 max 0 min Histogram: 2 0 0 0 0 0 0 0 0 2 diff --git a/examples/amoeba/log.water_dimer.hippo.4.test b/examples/amoeba/log.water_dimer.hippo.4.test deleted file mode 100644 index cd0767ae54..0000000000 --- a/examples/amoeba/log.water_dimer.hippo.4.test +++ /dev/null @@ -1,153 +0,0 @@ -LAMMPS (24 Mar 2022) -# water dimer with AMOEBA or HIPPO - -units real -boundary s s s - -atom_style amoeba -bond_style class2 -angle_style amoeba -dihedral_style none - -# per-atom properties required by AMOEBA or HIPPO - -fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom i_amgroup d_redID d_pval ghost yes -fix extra2 all property/atom i_polaxe d2_xyzaxis 3 - -# read data file - -read_data data.water_dimer.hippo fix amtype NULL "Tinker Types" -Reading data file ... - orthogonal box = (-1.463996 -0.756549 -0.009705) to (0.933234 0.75612 2.935934) - 2 by 1 by 2 MPI processor grid - reading atoms ... - 6 atoms - scanning bonds ... - 2 = max bonds/atom - scanning angles ... - 1 = max angles/atom - reading bonds ... - 4 bonds - reading angles ... - 2 angles -Finding 1-2 1-3 1-4 neighbors ... - special bond factors lj: 0 0 0 - special bond factors coul: 0 0 0 - 2 = max # of 1-2 neighbors - 1 = max # of 1-3 neighbors - 1 = max # of 1-4 neighbors - 2 = max # of special neighbors - special bonds CPU = 0.000 seconds - read_data CPU = 0.009 seconds - -# force field - -pair_style hippo -pair_coeff * * hippo_water.prm hippo_water.key - -special_bonds lj/coul 0.5 0.5 0.5 one/five yes -Finding 1-2 1-3 1-4 neighbors ... - special bond factors lj: 0.5 0.5 0.5 - special bond factors coul: 0.5 0.5 0.5 - 2 = max # of 1-2 neighbors - 1 = max # of 1-3 neighbors - 1 = max # of 1-4 neighbors - 2 = max # of 1-5 neighbors - 2 = max # of special neighbors - special bonds CPU = 0.001 seconds - -# thermo output - -compute virial all pressure NULL virial - -thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] - -dump 1 all custom 10 dump.water_dimer id type x y z fx fy fz -dump_modify 1 sort id - -# zero step run - -#run 0 - -# dynamics - -fix 1 all nve - -thermo 10 -run 100 -AMOEBA/HIPPO force field settings - repulsion: cut 10 taper 8 rscale 0 0 1 1 - qxfer: cut 10 taper 8 mscale 0 0 0.4 1 - dispersion: cut 10 aewald 0 dspscale 0 0 0.4 1 - multipole: cut 10 aewald 0 mscale 0 0 0.4 1 - polar: cut 10 aewald 0 - pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 0.2 1 1 1 d/u scale 0 1 - precondition: cut 4.5 - generated 0 of 1 mixed pair_coeff terms from geometric mixing rule -Neighbor list info ... - update every 1 steps, delay 10 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 12 - ghost atom cutoff = 12 - binsize = 6, bins = 1 1 1 - 1 neighbor lists, perpetual/occasional/extra = 1 0 0 - (1) pair hippo, perpetual - attributes: half, newton on - pair build: half/bin/newton - stencil: half/bin/3d - bin: standard -WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (../domain.cpp:974) - AMOEBA/HIPPO group count: 2 -Per MPI rank memory allocation (min/avg/max) = 49.18 | 49.31 | 49.44 Mbytes - Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] - 0 0 -5.0101954 0.025695395 0.51472748 0 0 0.54042288 -4.4697726 -11875.159 -38149.178 29162.678 -26638.977 -70.63422 -24614.614 -58.505595 - 10 0.75132894 -4.7952077 0.028216017 0.28494196 0 0 0.31315798 -4.4708519 -13243.822 12661.254 -49613.657 -2923.1497 69.449413 29456.684 56.087663 - 20 2.1716525 -5.0036265 0.011809223 0.48875837 0 0 0.50056759 -4.4706925 4371.5298 -22102.532 47044.297 -12243.648 -74.588915 -28903.762 -64.48154 - 30 2.9930198 -4.8261906 0.0091463366 0.30162756 0 0 0.3107739 -4.4708086 9992.4549 41973.539 -20985.339 8415.1715 67.458145 25027.414 40.261795 - 40 3.312268 -4.9802484 0.010400667 0.45076258 0 0 0.46116325 -4.4697189 21565.307 -11602.414 65186.215 10476.902 -83.374203 -33222.094 -64.700001 - 50 4.3187397 -4.8535614 0.0060313545 0.31244652 0 0 0.31847788 -4.4707168 11344.244 45839.35 -21073.749 8438.8954 73.345039 29422.636 43.897876 - 60 4.9127902 -5.0035271 0.0070589202 0.45246538 0 0 0.4595243 -4.4707824 6529.9354 -37107.891 46740.24 9015.2973 -90.41111 -34402.095 -53.57079 - 70 5.3145827 -4.8748857 0.025797484 0.29875503 0 0 0.32455252 -4.4711244 -10208.876 26324.134 -49272.688 -8697.2875 84.479942 36185.667 57.000355 - 80 3.8409793 -5.0262066 0.027669388 0.47104466 0 0 0.49871405 -4.4702464 -9777.1809 -52088.554 28053.855 -6033.4555 -94.607853 -44638.417 -59.108505 - 90 3.0683704 -4.8369716 0.035455716 0.28466932 0 0 0.32012503 -4.4711155 -10626.245 31066.635 -49425.925 -14107.889 87.765958 34632.905 52.101981 - 100 3.5262799 -4.9906817 0.016687539 0.45011301 0 0 0.46680055 -4.4713252 5216.7691 -34991.221 43883.163 6082.1058 -95.830393 -48645.129 -64.784334 -Loop time of 0.0133873 on 4 procs for 100 steps with 6 atoms - -Performance: 645.386 ns/day, 0.037 hours/ns, 7469.744 timesteps/s -98.4% CPU use with 4 MPI tasks x no OpenMP threads - -AMEOBA/HIPPO timing breakdown: - Init time: 0.000581606 0.0545512 - Repulse time: 0.000622984 5.84322 - Disp time: 0.000115637 1.0846 - Mpole time: 0.000994723 9.32991 - Induce time: 0.00737161 69.1413 - Polar time: 0.00091816 8.61179 - Qxfer time: 5.1997e-05 0.487701 - Total time: 0.0106617 - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 0.010579 | 0.010896 | 0.011085 | 0.2 | 81.39 -Bond | 1.3578e-05 | 4.3855e-05 | 7.6592e-05 | 0.0 | 0.33 -Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.00058533 | 0.00080957 | 0.0011064 | 0.0 | 6.05 -Output | 0.0011175 | 0.0011761 | 0.0013051 | 0.2 | 8.78 -Modify | 2.4304e-05 | 3.4805e-05 | 4.2149e-05 | 0.0 | 0.26 -Other | | 0.0004266 | | | 3.19 - -Nlocal: 1.5 ave 3 max 0 min -Histogram: 2 0 0 0 0 0 0 0 0 2 -Nghost: 4.5 ave 6 max 3 min -Histogram: 2 0 0 0 0 0 0 0 0 2 -Neighs: 3.75 ave 12 max 0 min -Histogram: 2 0 1 0 0 0 0 0 0 1 - -Total # of neighbors = 15 -Ave neighs/atom = 2.5 -Ave special neighs/atom = 2 -Neighbor list builds = 0 -Dangerous builds = 0 -Total wall time: 0:00:00 diff --git a/examples/amoeba/log.water_hexamer.amoeba.1 b/examples/amoeba/log.water_hexamer.amoeba.1 index af23d3ff82..5cfdcf9338 100644 --- a/examples/amoeba/log.water_hexamer.amoeba.1 +++ b/examples/amoeba/log.water_hexamer.amoeba.1 @@ -12,8 +12,8 @@ dihedral_style none # per-atom properties required by AMOEBA or HIPPO fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes -fix extra2 all property/atom i_polaxe +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 # read data file @@ -39,7 +39,7 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of special neighbors special bonds CPU = 0.000 seconds - read_data CPU = 0.007 seconds + read_data CPU = 0.009 seconds # force field @@ -96,7 +96,7 @@ Neighbor list info ... stencil: half/bin/3d bin: standard AMOEBA/HIPPO group count: 6 -Per MPI rank memory allocation (min/avg/max) = 9.804 | 9.804 | 9.804 Mbytes +Per MPI rank memory allocation (min/avg/max) = 49.53 | 49.53 | 49.53 Mbytes Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] 0 0 -48.469664 1.9820353 2.2499329 0 0 4.2319683 -44.237696 -26322.671 -28303.103 -27669.614 -22995.296 1312.6688 2624.8394 4042.0489 10 6.3616471 -46.626437 1.7910812 0.25704063 0 0 2.0481218 -44.255947 -23813.06 -24671.886 -17167.34 -30208.043 -474.208 -8339.5934 -5278.359 @@ -108,31 +108,30 @@ Per MPI rank memory allocation (min/avg/max) = 9.804 | 9.804 | 9.804 Mbytes 70 11.272241 -45.411622 0.07431614 0.51778317 0 0 0.59209931 -44.248316 32055.564 39306.193 30181.52 25601.501 1373.4778 -4501.0686 -2570.4767 80 14.011502 -46.081444 0.089688317 1.006928 0 0 1.0966163 -44.274812 25661.838 38836.598 12603.734 24205.867 -867.36437 -4211.9639 -2820.6725 90 17.659498 -46.247295 0.21744649 0.82687716 0 0 1.0443237 -44.308098 12101.207 19426.995 14142.311 1046.299 -2157.5418 -2141.2454 -2621.456 - -AMEOBA/HIPPO timing info: - Init time: 0.000298703 0.00766228 - Hal time: 0.00477252 12.2424 - Mpole time: 0.00429886 11.0274 - Induce time: 0.0189419 48.5895 - Polar time: 0.0106573 27.338 - Total time: 0.0389836 - 100 17.630532 -46.788272 0.61811601 0.9654966 0 0 1.5836126 -44.311254 -4455.3587 3961.5737 -11554.095 -7458.8012 -3120.9771 -1532.1706 -1499.0117 -Loop time of 0.0403763 on 1 procs for 100 steps with 18 atoms +Loop time of 0.0438592 on 1 procs for 100 steps with 18 atoms -Performance: 213.987 ns/day, 0.112 hours/ns, 2476.699 timesteps/s -96.9% CPU use with 1 MPI tasks x no OpenMP threads +Performance: 196.994 ns/day, 0.122 hours/ns, 2280.022 timesteps/s +95.1% CPU use with 1 MPI tasks x no OpenMP threads + +AMEOBA/HIPPO timing breakdown: + Init time: 0.000324764 0.00770058 + Hal time: 0.00500441 11.8661 + Mpole time: 0.00442974 10.5035 + Induce time: 0.0210286 49.8617 + Polar time: 0.0113696 26.9588 + Total time: 0.042174 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.039062 | 0.039062 | 0.039062 | 0.0 | 96.74 -Bond | 0.00018661 | 0.00018661 | 0.00018661 | 0.0 | 0.46 +Pair | 0.042221 | 0.042221 | 0.042221 | 0.0 | 96.26 +Bond | 0.00021632 | 0.00021632 | 0.00021632 | 0.0 | 0.49 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 1.665e-05 | 1.665e-05 | 1.665e-05 | 0.0 | 0.04 -Output | 0.0009741 | 0.0009741 | 0.0009741 | 0.0 | 2.41 -Modify | 6.7026e-05 | 6.7026e-05 | 6.7026e-05 | 0.0 | 0.17 -Other | | 7.005e-05 | | | 0.17 +Comm | 1.6322e-05 | 1.6322e-05 | 1.6322e-05 | 0.0 | 0.04 +Output | 0.0012472 | 0.0012472 | 0.0012472 | 0.0 | 2.84 +Modify | 7.9638e-05 | 7.9638e-05 | 7.9638e-05 | 0.0 | 0.18 +Other | | 7.889e-05 | | | 0.18 Nlocal: 18 ave 18 max 18 min Histogram: 1 0 0 0 0 0 0 0 0 0 diff --git a/examples/amoeba/log.water_hexamer.amoeba.1.test b/examples/amoeba/log.water_hexamer.amoeba.1.test deleted file mode 100644 index 5cfdcf9338..0000000000 --- a/examples/amoeba/log.water_hexamer.amoeba.1.test +++ /dev/null @@ -1,148 +0,0 @@ -LAMMPS (24 Mar 2022) -# water hexamer with AMOEBA or HIPPO - -units real -boundary s s s - -atom_style amoeba -bond_style class2 -angle_style amoeba -dihedral_style none - -# per-atom properties required by AMOEBA or HIPPO - -fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom i_amgroup d_redID d_pval ghost yes -fix extra2 all property/atom i_polaxe d2_xyzaxis 3 - -# read data file - -read_data data.water_hexamer.amoeba fix amtype NULL "Tinker Types" -Reading data file ... - orthogonal box = (-2.517835 -1.523041 -1.734766) to (2.675716 2.01883 2.220847) - 1 by 1 by 1 MPI processor grid - reading atoms ... - 18 atoms - scanning bonds ... - 2 = max bonds/atom - scanning angles ... - 1 = max angles/atom - reading bonds ... - 12 bonds - reading angles ... - 6 angles -Finding 1-2 1-3 1-4 neighbors ... - special bond factors lj: 0 0 0 - special bond factors coul: 0 0 0 - 2 = max # of 1-2 neighbors - 1 = max # of 1-3 neighbors - 1 = max # of 1-4 neighbors - 2 = max # of special neighbors - special bonds CPU = 0.000 seconds - read_data CPU = 0.009 seconds - -# force field - -pair_style amoeba -pair_coeff * * amoeba_water.prm amoeba_water.key - -special_bonds lj/coul 0.5 0.5 0.5 one/five yes -Finding 1-2 1-3 1-4 neighbors ... - special bond factors lj: 0.5 0.5 0.5 - special bond factors coul: 0.5 0.5 0.5 - 2 = max # of 1-2 neighbors - 1 = max # of 1-3 neighbors - 1 = max # of 1-4 neighbors - 2 = max # of 1-5 neighbors - 2 = max # of special neighbors - special bonds CPU = 0.000 seconds - -# thermo output - -compute virial all pressure NULL virial - -thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] - -dump 1 all custom 10 dump.water_hexamer id type x y z fx fy fz -dump_modify 1 sort id - -# zero step run - -#run 0 - -# dynamics - -fix 1 all nve - -thermo 10 -run 100 -AMOEBA/HIPPO force field settings - hal: cut 10 taper 8 vscale 0 0 1 1 - multipole: cut 10 aewald 0 mscale 0 0 0.4 1 - polar: cut 10 aewald 0 - pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 1 1 1 1 d/u scale 0 1 - precondition: cut 4.5 - generated 0 of 1 mixed pair_coeff terms from geometric mixing rule -Neighbor list info ... - update every 1 steps, delay 10 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 12 - ghost atom cutoff = 12 - binsize = 6, bins = 1 1 1 - 1 neighbor lists, perpetual/occasional/extra = 1 0 0 - (1) pair amoeba, perpetual - attributes: half, newton on - pair build: half/bin/newton - stencil: half/bin/3d - bin: standard - AMOEBA/HIPPO group count: 6 -Per MPI rank memory allocation (min/avg/max) = 49.53 | 49.53 | 49.53 Mbytes - Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] - 0 0 -48.469664 1.9820353 2.2499329 0 0 4.2319683 -44.237696 -26322.671 -28303.103 -27669.614 -22995.296 1312.6688 2624.8394 4042.0489 - 10 6.3616471 -46.626437 1.7910812 0.25704063 0 0 2.0481218 -44.255947 -23813.06 -24671.886 -17167.34 -30208.043 -474.208 -8339.5934 -5278.359 - 20 15.149798 -48.177533 1.1130818 2.007499 0 0 3.1205807 -44.289255 -16468.855 -20150.975 -18596.629 -12107.083 885.52697 6320.1867 3064.949 - 30 17.896968 -45.959274 0.54802739 0.19519937 0 0 0.74322676 -44.309141 -4749.0624 -9053.7792 -182.37209 -6721.7499 -2003.7641 -627.56998 -1658.1301 - 40 16.203813 -46.840973 0.1371751 1.5793326 0 0 1.7165077 -44.303357 9267.4858 6108.7966 4116.4548 16028.336 380.03787 8468.0648 4492.3331 - 50 11.584975 -45.166711 0.017120512 0.28622888 0 0 0.30334939 -44.276308 22189.511 21453.083 22339.471 21668.607 150.93139 1059.5253 200.0668 - 60 10.002055 -45.994946 0.037889337 1.1987062 0 0 1.2365956 -44.251509 30944.004 35801.925 19832.696 36241.326 2042.3054 2320.5193 1660.0834 - 70 11.272241 -45.411622 0.07431614 0.51778317 0 0 0.59209931 -44.248316 32055.564 39306.193 30181.52 25601.501 1373.4778 -4501.0686 -2570.4767 - 80 14.011502 -46.081444 0.089688317 1.006928 0 0 1.0966163 -44.274812 25661.838 38836.598 12603.734 24205.867 -867.36437 -4211.9639 -2820.6725 - 90 17.659498 -46.247295 0.21744649 0.82687716 0 0 1.0443237 -44.308098 12101.207 19426.995 14142.311 1046.299 -2157.5418 -2141.2454 -2621.456 - 100 17.630532 -46.788272 0.61811601 0.9654966 0 0 1.5836126 -44.311254 -4455.3587 3961.5737 -11554.095 -7458.8012 -3120.9771 -1532.1706 -1499.0117 -Loop time of 0.0438592 on 1 procs for 100 steps with 18 atoms - -Performance: 196.994 ns/day, 0.122 hours/ns, 2280.022 timesteps/s -95.1% CPU use with 1 MPI tasks x no OpenMP threads - -AMEOBA/HIPPO timing breakdown: - Init time: 0.000324764 0.00770058 - Hal time: 0.00500441 11.8661 - Mpole time: 0.00442974 10.5035 - Induce time: 0.0210286 49.8617 - Polar time: 0.0113696 26.9588 - Total time: 0.042174 - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 0.042221 | 0.042221 | 0.042221 | 0.0 | 96.26 -Bond | 0.00021632 | 0.00021632 | 0.00021632 | 0.0 | 0.49 -Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 1.6322e-05 | 1.6322e-05 | 1.6322e-05 | 0.0 | 0.04 -Output | 0.0012472 | 0.0012472 | 0.0012472 | 0.0 | 2.84 -Modify | 7.9638e-05 | 7.9638e-05 | 7.9638e-05 | 0.0 | 0.18 -Other | | 7.889e-05 | | | 0.18 - -Nlocal: 18 ave 18 max 18 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Nghost: 0 ave 0 max 0 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Neighs: 153 ave 153 max 153 min -Histogram: 1 0 0 0 0 0 0 0 0 0 - -Total # of neighbors = 153 -Ave neighs/atom = 8.5 -Ave special neighs/atom = 2 -Neighbor list builds = 0 -Dangerous builds = 0 -Total wall time: 0:00:00 diff --git a/examples/amoeba/log.water_hexamer.amoeba.4 b/examples/amoeba/log.water_hexamer.amoeba.4 index a76513acad..3a27656e78 100644 --- a/examples/amoeba/log.water_hexamer.amoeba.4 +++ b/examples/amoeba/log.water_hexamer.amoeba.4 @@ -12,8 +12,8 @@ dihedral_style none # per-atom properties required by AMOEBA or HIPPO fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes -fix extra2 all property/atom i_polaxe +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 # read data file @@ -38,8 +38,8 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-3 neighbors 1 = max # of 1-4 neighbors 2 = max # of special neighbors - special bonds CPU = 0.001 seconds - read_data CPU = 0.009 seconds + special bonds CPU = 0.000 seconds + read_data CPU = 0.008 seconds # force field @@ -55,7 +55,7 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of 1-5 neighbors 2 = max # of special neighbors - special bonds CPU = 0.001 seconds + special bonds CPU = 0.000 seconds # thermo output @@ -97,7 +97,7 @@ Neighbor list info ... bin: standard WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (../domain.cpp:974) AMOEBA/HIPPO group count: 6 -Per MPI rank memory allocation (min/avg/max) = 9.833 | 9.833 | 9.833 Mbytes +Per MPI rank memory allocation (min/avg/max) = 49.56 | 49.56 | 49.56 Mbytes Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] 0 0 -48.469664 1.9820353 2.2499329 0 0 4.2319683 -44.237696 -26322.671 -28303.103 -27669.614 -22995.296 1312.6688 2624.8394 4042.0489 10 6.3616471 -46.626437 1.7910812 0.25704063 0 0 2.0481218 -44.255947 -23813.06 -24671.886 -17167.34 -30208.043 -474.208 -8339.5934 -5278.359 @@ -109,31 +109,30 @@ Per MPI rank memory allocation (min/avg/max) = 9.833 | 9.833 | 9.833 Mbytes 70 11.272241 -45.411622 0.07431614 0.51778317 0 0 0.59209931 -44.248316 32055.564 39306.193 30181.52 25601.501 1373.4778 -4501.0686 -2570.4767 80 14.011502 -46.081444 0.089688317 1.006928 0 0 1.0966163 -44.274812 25661.838 38836.598 12603.734 24205.867 -867.36437 -4211.9639 -2820.6725 90 17.659498 -46.247295 0.21744649 0.82687716 0 0 1.0443237 -44.308098 12101.207 19426.995 14142.311 1046.299 -2157.5418 -2141.2454 -2621.456 - -AMEOBA/HIPPO timing info: - Init time: 0.000875735 0.0198199 - Hal time: 0.00136658 3.09288 - Mpole time: 0.0042176 9.5454 - Induce time: 0.0311498 70.4992 - Polar time: 0.00655957 14.8458 - Total time: 0.0441847 - 100 17.630532 -46.788272 0.61811601 0.9654966 0 0 1.5836126 -44.311254 -4455.3587 3961.5737 -11554.095 -7458.8012 -3120.9771 -1532.1706 -1499.0117 -Loop time of 0.0471312 on 4 procs for 100 steps with 18 atoms +Loop time of 0.0405754 on 4 procs for 100 steps with 18 atoms -Performance: 183.318 ns/day, 0.131 hours/ns, 2121.739 timesteps/s +Performance: 212.937 ns/day, 0.113 hours/ns, 2464.547 timesteps/s 98.9% CPU use with 4 MPI tasks x no OpenMP threads +AMEOBA/HIPPO timing breakdown: + Init time: 0.000756446 0.0198927 + Hal time: 0.00120064 3.15739 + Mpole time: 0.00338295 8.89637 + Induce time: 0.0273688 71.9733 + Polar time: 0.00530425 13.9489 + Total time: 0.0380263 + MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.044346 | 0.044424 | 0.044557 | 0.0 | 94.26 -Bond | 9.3929e-05 | 0.00010313 | 0.00011252 | 0.0 | 0.22 +Pair | 0.03816 | 0.038221 | 0.038312 | 0.0 | 94.20 +Bond | 7.0759e-05 | 8.5222e-05 | 0.00010449 | 0.0 | 0.21 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.00071684 | 0.00091755 | 0.0010385 | 0.0 | 1.95 -Output | 0.0011333 | 0.0012027 | 0.0013253 | 0.2 | 2.55 -Modify | 4.2618e-05 | 5.1978e-05 | 6.2018e-05 | 0.0 | 0.11 -Other | | 0.0004322 | | | 0.92 +Comm | 0.00065721 | 0.00081724 | 0.00093857 | 0.0 | 2.01 +Output | 0.0010275 | 0.0010663 | 0.0011758 | 0.2 | 2.63 +Modify | 3.3884e-05 | 4.422e-05 | 5.7037e-05 | 0.0 | 0.11 +Other | | 0.000341 | | | 0.84 Nlocal: 4.5 ave 6 max 3 min Histogram: 1 0 0 1 0 0 1 0 0 1 diff --git a/examples/amoeba/log.water_hexamer.amoeba.4.test b/examples/amoeba/log.water_hexamer.amoeba.4.test deleted file mode 100644 index 3a27656e78..0000000000 --- a/examples/amoeba/log.water_hexamer.amoeba.4.test +++ /dev/null @@ -1,149 +0,0 @@ -LAMMPS (24 Mar 2022) -# water hexamer with AMOEBA or HIPPO - -units real -boundary s s s - -atom_style amoeba -bond_style class2 -angle_style amoeba -dihedral_style none - -# per-atom properties required by AMOEBA or HIPPO - -fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom i_amgroup d_redID d_pval ghost yes -fix extra2 all property/atom i_polaxe d2_xyzaxis 3 - -# read data file - -read_data data.water_hexamer.amoeba fix amtype NULL "Tinker Types" -Reading data file ... - orthogonal box = (-2.517835 -1.523041 -1.734766) to (2.675716 2.01883 2.220847) - 2 by 1 by 2 MPI processor grid - reading atoms ... - 18 atoms - scanning bonds ... - 2 = max bonds/atom - scanning angles ... - 1 = max angles/atom - reading bonds ... - 12 bonds - reading angles ... - 6 angles -Finding 1-2 1-3 1-4 neighbors ... - special bond factors lj: 0 0 0 - special bond factors coul: 0 0 0 - 2 = max # of 1-2 neighbors - 1 = max # of 1-3 neighbors - 1 = max # of 1-4 neighbors - 2 = max # of special neighbors - special bonds CPU = 0.000 seconds - read_data CPU = 0.008 seconds - -# force field - -pair_style amoeba -pair_coeff * * amoeba_water.prm amoeba_water.key - -special_bonds lj/coul 0.5 0.5 0.5 one/five yes -Finding 1-2 1-3 1-4 neighbors ... - special bond factors lj: 0.5 0.5 0.5 - special bond factors coul: 0.5 0.5 0.5 - 2 = max # of 1-2 neighbors - 1 = max # of 1-3 neighbors - 1 = max # of 1-4 neighbors - 2 = max # of 1-5 neighbors - 2 = max # of special neighbors - special bonds CPU = 0.000 seconds - -# thermo output - -compute virial all pressure NULL virial - -thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] - -dump 1 all custom 10 dump.water_hexamer id type x y z fx fy fz -dump_modify 1 sort id - -# zero step run - -#run 0 - -# dynamics - -fix 1 all nve - -thermo 10 -run 100 -AMOEBA/HIPPO force field settings - hal: cut 10 taper 8 vscale 0 0 1 1 - multipole: cut 10 aewald 0 mscale 0 0 0.4 1 - polar: cut 10 aewald 0 - pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 1 1 1 1 d/u scale 0 1 - precondition: cut 4.5 - generated 0 of 1 mixed pair_coeff terms from geometric mixing rule -Neighbor list info ... - update every 1 steps, delay 10 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 12 - ghost atom cutoff = 12 - binsize = 6, bins = 1 1 1 - 1 neighbor lists, perpetual/occasional/extra = 1 0 0 - (1) pair amoeba, perpetual - attributes: half, newton on - pair build: half/bin/newton - stencil: half/bin/3d - bin: standard -WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (../domain.cpp:974) - AMOEBA/HIPPO group count: 6 -Per MPI rank memory allocation (min/avg/max) = 49.56 | 49.56 | 49.56 Mbytes - Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] - 0 0 -48.469664 1.9820353 2.2499329 0 0 4.2319683 -44.237696 -26322.671 -28303.103 -27669.614 -22995.296 1312.6688 2624.8394 4042.0489 - 10 6.3616471 -46.626437 1.7910812 0.25704063 0 0 2.0481218 -44.255947 -23813.06 -24671.886 -17167.34 -30208.043 -474.208 -8339.5934 -5278.359 - 20 15.149798 -48.177533 1.1130818 2.007499 0 0 3.1205807 -44.289255 -16468.855 -20150.975 -18596.629 -12107.083 885.52697 6320.1867 3064.949 - 30 17.896968 -45.959274 0.54802739 0.19519937 0 0 0.74322676 -44.309141 -4749.0624 -9053.7792 -182.37209 -6721.7499 -2003.7641 -627.56998 -1658.1301 - 40 16.203813 -46.840973 0.1371751 1.5793326 0 0 1.7165077 -44.303357 9267.4858 6108.7966 4116.4548 16028.336 380.03787 8468.0648 4492.3331 - 50 11.584975 -45.166711 0.017120512 0.28622888 0 0 0.30334939 -44.276308 22189.511 21453.083 22339.471 21668.607 150.93139 1059.5253 200.0668 - 60 10.002055 -45.994946 0.037889337 1.1987062 0 0 1.2365956 -44.251509 30944.004 35801.925 19832.696 36241.326 2042.3054 2320.5193 1660.0834 - 70 11.272241 -45.411622 0.07431614 0.51778317 0 0 0.59209931 -44.248316 32055.564 39306.193 30181.52 25601.501 1373.4778 -4501.0686 -2570.4767 - 80 14.011502 -46.081444 0.089688317 1.006928 0 0 1.0966163 -44.274812 25661.838 38836.598 12603.734 24205.867 -867.36437 -4211.9639 -2820.6725 - 90 17.659498 -46.247295 0.21744649 0.82687716 0 0 1.0443237 -44.308098 12101.207 19426.995 14142.311 1046.299 -2157.5418 -2141.2454 -2621.456 - 100 17.630532 -46.788272 0.61811601 0.9654966 0 0 1.5836126 -44.311254 -4455.3587 3961.5737 -11554.095 -7458.8012 -3120.9771 -1532.1706 -1499.0117 -Loop time of 0.0405754 on 4 procs for 100 steps with 18 atoms - -Performance: 212.937 ns/day, 0.113 hours/ns, 2464.547 timesteps/s -98.9% CPU use with 4 MPI tasks x no OpenMP threads - -AMEOBA/HIPPO timing breakdown: - Init time: 0.000756446 0.0198927 - Hal time: 0.00120064 3.15739 - Mpole time: 0.00338295 8.89637 - Induce time: 0.0273688 71.9733 - Polar time: 0.00530425 13.9489 - Total time: 0.0380263 - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 0.03816 | 0.038221 | 0.038312 | 0.0 | 94.20 -Bond | 7.0759e-05 | 8.5222e-05 | 0.00010449 | 0.0 | 0.21 -Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.00065721 | 0.00081724 | 0.00093857 | 0.0 | 2.01 -Output | 0.0010275 | 0.0010663 | 0.0011758 | 0.2 | 2.63 -Modify | 3.3884e-05 | 4.422e-05 | 5.7037e-05 | 0.0 | 0.11 -Other | | 0.000341 | | | 0.84 - -Nlocal: 4.5 ave 6 max 3 min -Histogram: 1 0 0 1 0 0 1 0 0 1 -Nghost: 13.5 ave 15 max 12 min -Histogram: 1 0 0 1 0 0 1 0 0 1 -Neighs: 38.25 ave 77 max 9 min -Histogram: 2 0 0 0 0 0 1 0 0 1 - -Total # of neighbors = 153 -Ave neighs/atom = 8.5 -Ave special neighs/atom = 2 -Neighbor list builds = 0 -Dangerous builds = 0 -Total wall time: 0:00:00 diff --git a/examples/amoeba/log.water_hexamer.hippo.1 b/examples/amoeba/log.water_hexamer.hippo.1 index 520fb3e3e0..15d107a11b 100644 --- a/examples/amoeba/log.water_hexamer.hippo.1 +++ b/examples/amoeba/log.water_hexamer.hippo.1 @@ -12,8 +12,8 @@ dihedral_style none # per-atom properties required by AMOEBA or HIPPO fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes -fix extra2 all property/atom i_polaxe +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 # read data file @@ -98,7 +98,7 @@ Neighbor list info ... stencil: half/bin/3d bin: standard AMOEBA/HIPPO group count: 6 -Per MPI rank memory allocation (min/avg/max) = 9.804 | 9.804 | 9.804 Mbytes +Per MPI rank memory allocation (min/avg/max) = 49.1 | 49.1 | 49.1 Mbytes Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] 0 0 -47.362156 1.9820353 1.6634749 0 0 3.6455102 -43.716646 -34513.768 -42206.078 -31383.641 -29951.584 2850.1184 3579.9253 5768.3698 10 11.52238 -45.959856 1.53397 0.085100522 0 0 1.6190706 -43.756903 -28644.676 -34867.94 -19324.955 -32842.522 -370.63233 -6452.0859 -4002.3535 @@ -110,33 +110,32 @@ Per MPI rank memory allocation (min/avg/max) = 9.804 | 9.804 | 9.804 Mbytes 70 26.129957 -46.022729 0.30434543 0.56770169 0 0 0.87204711 -43.826579 3919.9866 -2755.6905 11500.428 517.54333 5626.9543 -2238.5786 86.305984 80 17.768494 -46.309777 1.1680612 0.45551823 0 0 1.6235794 -43.785801 -18335.898 -22168.789 -14488.992 -20048.346 7343.173 -2646.2196 -2525.6625 90 8.3822494 -47.063502 2.0182644 0.88875358 0 0 2.9070179 -43.731724 -33693.203 -43487.996 -15178.35 -43214.494 2412.6411 1993.0113 1780.7512 - -AMEOBA/HIPPO timing info: - Init time: 0.000305988 0.00772963 - Repls time: 0.00615705 15.5535 - Disp time: 0.00270421 6.83116 - Mpole time: 0.00727575 18.3794 - Induce time: 0.0137304 34.6848 - Polar time: 0.00789202 19.9362 - Qxfer time: 0.00151645 3.83073 - Total time: 0.0395864 - 100 8.6486333 -46.517402 1.9551958 0.38696887 0 0 2.3421647 -43.736979 -34734.97 -34372.659 -28372.146 -42286.799 226.18821 40.353457 -755.93912 -Loop time of 0.0411107 on 1 procs for 100 steps with 18 atoms +Loop time of 0.0399433 on 1 procs for 100 steps with 18 atoms -Performance: 210.164 ns/day, 0.114 hours/ns, 2432.456 timesteps/s -94.5% CPU use with 1 MPI tasks x no OpenMP threads +Performance: 216.307 ns/day, 0.111 hours/ns, 2503.548 timesteps/s +92.6% CPU use with 1 MPI tasks x no OpenMP threads + +AMEOBA/HIPPO timing breakdown: + Init time: 0.000295019 0.00770171 + Repulse time: 0.00594736 15.5261 + Disp time: 0.00261218 6.81931 + Mpole time: 0.0069314 18.095 + Induce time: 0.013694 35.7492 + Polar time: 0.00744631 19.4392 + Qxfer time: 0.001375 3.58954 + Total time: 0.0383057 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.039681 | 0.039681 | 0.039681 | 0.0 | 96.52 -Bond | 0.00018196 | 0.00018196 | 0.00018196 | 0.0 | 0.44 +Pair | 0.038344 | 0.038344 | 0.038344 | 0.0 | 96.00 +Bond | 0.00017707 | 0.00017707 | 0.00017707 | 0.0 | 0.44 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 1.8274e-05 | 1.8274e-05 | 1.8274e-05 | 0.0 | 0.04 -Output | 0.0010806 | 0.0010806 | 0.0010806 | 0.0 | 2.63 -Modify | 7.5438e-05 | 7.5438e-05 | 7.5438e-05 | 0.0 | 0.18 -Other | | 7.382e-05 | | | 0.18 +Comm | 1.5549e-05 | 1.5549e-05 | 1.5549e-05 | 0.0 | 0.04 +Output | 0.0012682 | 0.0012682 | 0.0012682 | 0.0 | 3.18 +Modify | 7.0869e-05 | 7.0869e-05 | 7.0869e-05 | 0.0 | 0.18 +Other | | 6.745e-05 | | | 0.17 Nlocal: 18 ave 18 max 18 min Histogram: 1 0 0 0 0 0 0 0 0 0 diff --git a/examples/amoeba/log.water_hexamer.hippo.1.test b/examples/amoeba/log.water_hexamer.hippo.1.test deleted file mode 100644 index 15d107a11b..0000000000 --- a/examples/amoeba/log.water_hexamer.hippo.1.test +++ /dev/null @@ -1,152 +0,0 @@ -LAMMPS (24 Mar 2022) -# water hexamer with AMOEBA or HIPPO - -units real -boundary s s s - -atom_style amoeba -bond_style class2 -angle_style amoeba -dihedral_style none - -# per-atom properties required by AMOEBA or HIPPO - -fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom i_amgroup d_redID d_pval ghost yes -fix extra2 all property/atom i_polaxe d2_xyzaxis 3 - -# read data file - -read_data data.water_hexamer.hippo fix amtype NULL "Tinker Types" -Reading data file ... - orthogonal box = (-2.517835 -1.523041 -1.734766) to (2.675716 2.01883 2.220847) - 1 by 1 by 1 MPI processor grid - reading atoms ... - 18 atoms - scanning bonds ... - 2 = max bonds/atom - scanning angles ... - 1 = max angles/atom - reading bonds ... - 12 bonds - reading angles ... - 6 angles -Finding 1-2 1-3 1-4 neighbors ... - special bond factors lj: 0 0 0 - special bond factors coul: 0 0 0 - 2 = max # of 1-2 neighbors - 1 = max # of 1-3 neighbors - 1 = max # of 1-4 neighbors - 2 = max # of special neighbors - special bonds CPU = 0.000 seconds - read_data CPU = 0.007 seconds - -# force field - -pair_style hippo -pair_coeff * * hippo_water.prm hippo_water.key - -special_bonds lj/coul 0.5 0.5 0.5 one/five yes -Finding 1-2 1-3 1-4 neighbors ... - special bond factors lj: 0.5 0.5 0.5 - special bond factors coul: 0.5 0.5 0.5 - 2 = max # of 1-2 neighbors - 1 = max # of 1-3 neighbors - 1 = max # of 1-4 neighbors - 2 = max # of 1-5 neighbors - 2 = max # of special neighbors - special bonds CPU = 0.000 seconds - -# thermo output - -compute virial all pressure NULL virial - -thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] - -dump 1 all custom 10 dump.water_hexamer id type x y z fx fy fz -dump_modify 1 sort id - -# zero step run - -#run 0 - -# dynamics - -fix 1 all nve - -thermo 10 -run 100 -AMOEBA/HIPPO force field settings - repulsion: cut 10 taper 8 rscale 0 0 1 1 - qxfer: cut 10 taper 8 mscale 0 0 0.4 1 - dispersion: cut 10 aewald 0 dspscale 0 0 0.4 1 - multipole: cut 10 aewald 0 mscale 0 0 0.4 1 - polar: cut 10 aewald 0 - pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 0.2 1 1 1 d/u scale 0 1 - precondition: cut 4.5 - generated 0 of 1 mixed pair_coeff terms from geometric mixing rule -Neighbor list info ... - update every 1 steps, delay 10 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 12 - ghost atom cutoff = 12 - binsize = 6, bins = 1 1 1 - 1 neighbor lists, perpetual/occasional/extra = 1 0 0 - (1) pair hippo, perpetual - attributes: half, newton on - pair build: half/bin/newton - stencil: half/bin/3d - bin: standard - AMOEBA/HIPPO group count: 6 -Per MPI rank memory allocation (min/avg/max) = 49.1 | 49.1 | 49.1 Mbytes - Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] - 0 0 -47.362156 1.9820353 1.6634749 0 0 3.6455102 -43.716646 -34513.768 -42206.078 -31383.641 -29951.584 2850.1184 3579.9253 5768.3698 - 10 11.52238 -45.959856 1.53397 0.085100522 0 0 1.6190706 -43.756903 -28644.676 -34867.94 -19324.955 -32842.522 -370.63233 -6452.0859 -4002.3535 - 20 20.237283 -46.772008 0.54762833 1.3835192 0 0 1.9311476 -43.815361 -10546.356 -10116.359 -17063.425 -6393.701 -1166.7608 4243.6327 3493.9596 - 30 20.666374 -45.011106 0.086797459 0.071122604 0 0 0.15792006 -43.805943 13150.762 15882.022 10964.553 10630.278 -6754.7642 -432.29165 -3783.115 - 40 10.639014 -45.430939 0.18926921 0.96410995 0 0 1.1533792 -43.738441 33402.664 41252.58 19726.586 38211.875 -6166.03 6081.5692 1815.7739 - 50 10.992432 -44.741108 0.19575431 0.25851128 0 0 0.45426559 -43.729815 37696.923 41572.466 33299.43 37168.141 -3254.5134 2.9639226 -1017.3669 - 60 19.748633 -45.461264 0.035287281 0.63217389 0 0 0.66746117 -43.793065 26212.839 28825.788 16048.096 31876.925 3504.5461 135.3505 420.28566 - 70 26.129957 -46.022729 0.30434543 0.56770169 0 0 0.87204711 -43.826579 3919.9866 -2755.6905 11500.428 517.54333 5626.9543 -2238.5786 86.305984 - 80 17.768494 -46.309777 1.1680612 0.45551823 0 0 1.6235794 -43.785801 -18335.898 -22168.789 -14488.992 -20048.346 7343.173 -2646.2196 -2525.6625 - 90 8.3822494 -47.063502 2.0182644 0.88875358 0 0 2.9070179 -43.731724 -33693.203 -43487.996 -15178.35 -43214.494 2412.6411 1993.0113 1780.7512 - 100 8.6486333 -46.517402 1.9551958 0.38696887 0 0 2.3421647 -43.736979 -34734.97 -34372.659 -28372.146 -42286.799 226.18821 40.353457 -755.93912 -Loop time of 0.0399433 on 1 procs for 100 steps with 18 atoms - -Performance: 216.307 ns/day, 0.111 hours/ns, 2503.548 timesteps/s -92.6% CPU use with 1 MPI tasks x no OpenMP threads - -AMEOBA/HIPPO timing breakdown: - Init time: 0.000295019 0.00770171 - Repulse time: 0.00594736 15.5261 - Disp time: 0.00261218 6.81931 - Mpole time: 0.0069314 18.095 - Induce time: 0.013694 35.7492 - Polar time: 0.00744631 19.4392 - Qxfer time: 0.001375 3.58954 - Total time: 0.0383057 - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 0.038344 | 0.038344 | 0.038344 | 0.0 | 96.00 -Bond | 0.00017707 | 0.00017707 | 0.00017707 | 0.0 | 0.44 -Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 1.5549e-05 | 1.5549e-05 | 1.5549e-05 | 0.0 | 0.04 -Output | 0.0012682 | 0.0012682 | 0.0012682 | 0.0 | 3.18 -Modify | 7.0869e-05 | 7.0869e-05 | 7.0869e-05 | 0.0 | 0.18 -Other | | 6.745e-05 | | | 0.17 - -Nlocal: 18 ave 18 max 18 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Nghost: 0 ave 0 max 0 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Neighs: 153 ave 153 max 153 min -Histogram: 1 0 0 0 0 0 0 0 0 0 - -Total # of neighbors = 153 -Ave neighs/atom = 8.5 -Ave special neighs/atom = 2 -Neighbor list builds = 0 -Dangerous builds = 0 -Total wall time: 0:00:00 diff --git a/examples/amoeba/log.water_hexamer.hippo.4 b/examples/amoeba/log.water_hexamer.hippo.4 index 4800cbd6d5..4b0d913edd 100644 --- a/examples/amoeba/log.water_hexamer.hippo.4 +++ b/examples/amoeba/log.water_hexamer.hippo.4 @@ -12,8 +12,8 @@ dihedral_style none # per-atom properties required by AMOEBA or HIPPO fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom i_amgroup d_redID d_xaxis d_yaxis d_zaxis d_pval ghost yes -fix extra2 all property/atom i_polaxe +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 # read data file @@ -39,7 +39,7 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of special neighbors special bonds CPU = 0.000 seconds - read_data CPU = 0.007 seconds + read_data CPU = 0.008 seconds # force field @@ -99,7 +99,7 @@ Neighbor list info ... bin: standard WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (../domain.cpp:974) AMOEBA/HIPPO group count: 6 -Per MPI rank memory allocation (min/avg/max) = 9.833 | 9.833 | 9.833 Mbytes +Per MPI rank memory allocation (min/avg/max) = 49.13 | 49.13 | 49.13 Mbytes Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] 0 0 -47.362156 1.9820353 1.6634749 0 0 3.6455102 -43.716646 -34513.768 -42206.078 -31383.641 -29951.584 2850.1184 3579.9253 5768.3698 10 11.52238 -45.959856 1.53397 0.085100522 0 0 1.6190706 -43.756903 -28644.676 -34867.94 -19324.955 -32842.522 -370.63233 -6452.0859 -4002.3535 @@ -111,33 +111,32 @@ Per MPI rank memory allocation (min/avg/max) = 9.833 | 9.833 | 9.833 Mbytes 70 26.129957 -46.022729 0.30434543 0.56770169 0 0 0.87204711 -43.826579 3919.9866 -2755.6905 11500.428 517.54333 5626.9543 -2238.5786 86.305984 80 17.768494 -46.309777 1.1680612 0.45551823 0 0 1.6235794 -43.785801 -18335.898 -22168.789 -14488.992 -20048.346 7343.173 -2646.2196 -2525.6625 90 8.3822494 -47.063502 2.0182644 0.88875358 0 0 2.9070179 -43.731724 -33693.203 -43487.996 -15178.35 -43214.494 2412.6411 1993.0113 1780.7512 - -AMEOBA/HIPPO timing info: - Init time: 0.000674024 0.0214167 - Repls time: 0.00313927 9.97487 - Disp time: 0.000678053 2.15448 - Mpole time: 0.00411311 13.0692 - Induce time: 0.018633 59.2054 - Polar time: 0.00385369 12.2449 - Qxfer time: 0.000376264 1.19556 - Total time: 0.0314718 - 100 8.6486333 -46.517402 1.9551958 0.38696887 0 0 2.3421647 -43.736979 -34734.97 -34372.659 -28372.146 -42286.799 226.18821 40.353457 -755.93912 -Loop time of 0.0345189 on 4 procs for 100 steps with 18 atoms +Loop time of 0.033787 on 4 procs for 100 steps with 18 atoms -Performance: 250.298 ns/day, 0.096 hours/ns, 2896.962 timesteps/s -97.4% CPU use with 4 MPI tasks x no OpenMP threads +Performance: 255.719 ns/day, 0.094 hours/ns, 2959.715 timesteps/s +99.9% CPU use with 4 MPI tasks x no OpenMP threads + +AMEOBA/HIPPO timing breakdown: + Init time: 0.000724905 0.0236438 + Repulse time: 0.00306516 9.99746 + Disp time: 0.000637502 2.07931 + Mpole time: 0.00397577 12.9676 + Induce time: 0.0181268 59.123 + Polar time: 0.00377543 12.3141 + Qxfer time: 0.000349256 1.13915 + Total time: 0.0306594 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.031394 | 0.031738 | 0.032246 | 0.2 | 91.94 -Bond | 5.8552e-05 | 7.4876e-05 | 9.4475e-05 | 0.0 | 0.22 +Pair | 0.030576 | 0.030875 | 0.031306 | 0.2 | 91.38 +Bond | 6.4191e-05 | 7.956e-05 | 0.0001014 | 0.0 | 0.24 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.00068606 | 0.0012736 | 0.0016838 | 1.2 | 3.69 -Output | 0.00098398 | 0.0010248 | 0.0011389 | 0.2 | 2.97 -Modify | 3.693e-05 | 4.5649e-05 | 5.4845e-05 | 0.0 | 0.13 -Other | | 0.0003625 | | | 1.05 +Comm | 0.00072972 | 0.0012341 | 0.0015501 | 1.0 | 3.65 +Output | 0.0011293 | 0.0011806 | 0.0012922 | 0.2 | 3.49 +Modify | 4.0541e-05 | 4.5677e-05 | 5.4304e-05 | 0.0 | 0.14 +Other | | 0.0003717 | | | 1.10 Nlocal: 4.5 ave 6 max 3 min Histogram: 1 0 0 1 0 0 1 0 0 1 diff --git a/examples/amoeba/log.water_hexamer.hippo.4.test b/examples/amoeba/log.water_hexamer.hippo.4.test deleted file mode 100644 index 4b0d913edd..0000000000 --- a/examples/amoeba/log.water_hexamer.hippo.4.test +++ /dev/null @@ -1,153 +0,0 @@ -LAMMPS (24 Mar 2022) -# water hexamer with AMOEBA or HIPPO - -units real -boundary s s s - -atom_style amoeba -bond_style class2 -angle_style amoeba -dihedral_style none - -# per-atom properties required by AMOEBA or HIPPO - -fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom i_amgroup d_redID d_pval ghost yes -fix extra2 all property/atom i_polaxe d2_xyzaxis 3 - -# read data file - -read_data data.water_hexamer.hippo fix amtype NULL "Tinker Types" -Reading data file ... - orthogonal box = (-2.517835 -1.523041 -1.734766) to (2.675716 2.01883 2.220847) - 2 by 1 by 2 MPI processor grid - reading atoms ... - 18 atoms - scanning bonds ... - 2 = max bonds/atom - scanning angles ... - 1 = max angles/atom - reading bonds ... - 12 bonds - reading angles ... - 6 angles -Finding 1-2 1-3 1-4 neighbors ... - special bond factors lj: 0 0 0 - special bond factors coul: 0 0 0 - 2 = max # of 1-2 neighbors - 1 = max # of 1-3 neighbors - 1 = max # of 1-4 neighbors - 2 = max # of special neighbors - special bonds CPU = 0.000 seconds - read_data CPU = 0.008 seconds - -# force field - -pair_style hippo -pair_coeff * * hippo_water.prm hippo_water.key - -special_bonds lj/coul 0.5 0.5 0.5 one/five yes -Finding 1-2 1-3 1-4 neighbors ... - special bond factors lj: 0.5 0.5 0.5 - special bond factors coul: 0.5 0.5 0.5 - 2 = max # of 1-2 neighbors - 1 = max # of 1-3 neighbors - 1 = max # of 1-4 neighbors - 2 = max # of 1-5 neighbors - 2 = max # of special neighbors - special bonds CPU = 0.000 seconds - -# thermo output - -compute virial all pressure NULL virial - -thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] - -dump 1 all custom 10 dump.water_hexamer id type x y z fx fy fz -dump_modify 1 sort id - -# zero step run - -#run 0 - -# dynamics - -fix 1 all nve - -thermo 10 -run 100 -AMOEBA/HIPPO force field settings - repulsion: cut 10 taper 8 rscale 0 0 1 1 - qxfer: cut 10 taper 8 mscale 0 0 0.4 1 - dispersion: cut 10 aewald 0 dspscale 0 0 0.4 1 - multipole: cut 10 aewald 0 mscale 0 0 0.4 1 - polar: cut 10 aewald 0 - pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 0.2 1 1 1 d/u scale 0 1 - precondition: cut 4.5 - generated 0 of 1 mixed pair_coeff terms from geometric mixing rule -Neighbor list info ... - update every 1 steps, delay 10 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 12 - ghost atom cutoff = 12 - binsize = 6, bins = 1 1 1 - 1 neighbor lists, perpetual/occasional/extra = 1 0 0 - (1) pair hippo, perpetual - attributes: half, newton on - pair build: half/bin/newton - stencil: half/bin/3d - bin: standard -WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (../domain.cpp:974) - AMOEBA/HIPPO group count: 6 -Per MPI rank memory allocation (min/avg/max) = 49.13 | 49.13 | 49.13 Mbytes - Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] - 0 0 -47.362156 1.9820353 1.6634749 0 0 3.6455102 -43.716646 -34513.768 -42206.078 -31383.641 -29951.584 2850.1184 3579.9253 5768.3698 - 10 11.52238 -45.959856 1.53397 0.085100522 0 0 1.6190706 -43.756903 -28644.676 -34867.94 -19324.955 -32842.522 -370.63233 -6452.0859 -4002.3535 - 20 20.237283 -46.772008 0.54762833 1.3835192 0 0 1.9311476 -43.815361 -10546.356 -10116.359 -17063.425 -6393.701 -1166.7608 4243.6327 3493.9596 - 30 20.666374 -45.011106 0.086797459 0.071122604 0 0 0.15792006 -43.805943 13150.762 15882.022 10964.553 10630.278 -6754.7642 -432.29165 -3783.115 - 40 10.639014 -45.430939 0.18926921 0.96410995 0 0 1.1533792 -43.738441 33402.664 41252.58 19726.586 38211.875 -6166.03 6081.5692 1815.7739 - 50 10.992432 -44.741108 0.19575431 0.25851128 0 0 0.45426559 -43.729815 37696.923 41572.466 33299.43 37168.141 -3254.5134 2.9639226 -1017.3669 - 60 19.748633 -45.461264 0.035287281 0.63217389 0 0 0.66746117 -43.793065 26212.839 28825.788 16048.096 31876.925 3504.5461 135.3505 420.28566 - 70 26.129957 -46.022729 0.30434543 0.56770169 0 0 0.87204711 -43.826579 3919.9866 -2755.6905 11500.428 517.54333 5626.9543 -2238.5786 86.305984 - 80 17.768494 -46.309777 1.1680612 0.45551823 0 0 1.6235794 -43.785801 -18335.898 -22168.789 -14488.992 -20048.346 7343.173 -2646.2196 -2525.6625 - 90 8.3822494 -47.063502 2.0182644 0.88875358 0 0 2.9070179 -43.731724 -33693.203 -43487.996 -15178.35 -43214.494 2412.6411 1993.0113 1780.7512 - 100 8.6486333 -46.517402 1.9551958 0.38696887 0 0 2.3421647 -43.736979 -34734.97 -34372.659 -28372.146 -42286.799 226.18821 40.353457 -755.93912 -Loop time of 0.033787 on 4 procs for 100 steps with 18 atoms - -Performance: 255.719 ns/day, 0.094 hours/ns, 2959.715 timesteps/s -99.9% CPU use with 4 MPI tasks x no OpenMP threads - -AMEOBA/HIPPO timing breakdown: - Init time: 0.000724905 0.0236438 - Repulse time: 0.00306516 9.99746 - Disp time: 0.000637502 2.07931 - Mpole time: 0.00397577 12.9676 - Induce time: 0.0181268 59.123 - Polar time: 0.00377543 12.3141 - Qxfer time: 0.000349256 1.13915 - Total time: 0.0306594 - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 0.030576 | 0.030875 | 0.031306 | 0.2 | 91.38 -Bond | 6.4191e-05 | 7.956e-05 | 0.0001014 | 0.0 | 0.24 -Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.00072972 | 0.0012341 | 0.0015501 | 1.0 | 3.65 -Output | 0.0011293 | 0.0011806 | 0.0012922 | 0.2 | 3.49 -Modify | 4.0541e-05 | 4.5677e-05 | 5.4304e-05 | 0.0 | 0.14 -Other | | 0.0003717 | | | 1.10 - -Nlocal: 4.5 ave 6 max 3 min -Histogram: 1 0 0 1 0 0 1 0 0 1 -Nghost: 13.5 ave 15 max 12 min -Histogram: 1 0 0 1 0 0 1 0 0 1 -Neighs: 38.25 ave 77 max 9 min -Histogram: 2 0 0 0 0 0 1 0 0 1 - -Total # of neighbors = 153 -Ave neighs/atom = 8.5 -Ave special neighs/atom = 2 -Neighbor list builds = 0 -Dangerous builds = 0 -Total wall time: 0:00:00 From 3ee209d0314c989203c8f954d90b3c69cdd9c77a Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 25 May 2022 06:35:08 -0400 Subject: [PATCH 208/585] update singularity definition for ubuntu22.04LTS This now has the changes required to include the openkim-api package --- tools/singularity/ubuntu22.04.def | 43 +++++++++++++++---------------- 1 file changed, 21 insertions(+), 22 deletions(-) diff --git a/tools/singularity/ubuntu22.04.def b/tools/singularity/ubuntu22.04.def index cf4aa7e175..62a24e81f3 100644 --- a/tools/singularity/ubuntu22.04.def +++ b/tools/singularity/ubuntu22.04.def @@ -4,8 +4,8 @@ From: ubuntu:22.04 %post export DEBIAN_FRONTEND=noninteractive apt-get update - apt-get install --no-install-recommends -y software-properties-common -# add-apt-repository ppa:openkim/latest + apt-get install --no-install-recommends -y software-properties-common gpg gpg-agent + add-apt-repository ppa:openkim/latest apt-get update apt-get upgrade --no-install-recommends -y apt-get install --no-install-recommends -y \ @@ -74,29 +74,28 @@ From: ubuntu:22.04 zstd \ libyaml-cpp-dev \ libkim-api-dev \ - gpg-agent \ -# openkim-models + openkim-models -# ########################################################################### -# # KIM-API -# ########################################################################### -# -# # workaround for installing files in /usr/share/doc inside of a container -# sed -i 's/path-exclude=\/usr\/share\/doc/#path-exclude=\/usr\/share\/doc/g' /etc/dpkg/dpkg.cfg.d/excludes -# apt-get install -y libkim-api-doc -# sed -i 's/#path-exclude=\/usr\/share\/doc/path-exclude=\/usr\/share\/doc/g' /etc/dpkg/dpkg.cfg.d/excludes -# -# # install KIM models -# KIM_API_EXAMPLES=/usr/share/doc/libkim-api-dev/examples + ########################################################################### + # KIM-API + ########################################################################### + + # workaround for installing files in /usr/share/doc inside of a container + sed -i 's/path-exclude=\/usr\/share\/doc/#path-exclude=\/usr\/share\/doc/g' /etc/dpkg/dpkg.cfg.d/excludes + apt-get install -y libkim-api-doc + sed -i 's/#path-exclude=\/usr\/share\/doc/path-exclude=\/usr\/share\/doc/g' /etc/dpkg/dpkg.cfg.d/excludes + + # install KIM models + KIM_API_EXAMPLES=/usr/share/doc/libkim-api-dev/examples # gunzip $KIM_API_EXAMPLES/portable-models/LennardJones612_UniversalShifted__MO_959249795837_003/LennardJones612_UniversalShifted.params.gz # gunzip $KIM_API_EXAMPLES/model-drivers/ex_model_driver_P_LJ/ex_model_driver_P_LJ.f90.gz -# -# kim-api-collections-management install system $KIM_API_EXAMPLES/model-drivers/LennardJones612__MD_414112407348_003 -# kim-api-collections-management install system $KIM_API_EXAMPLES/model-drivers/ex_model_driver_P_LJ -# kim-api-collections-management install system $KIM_API_EXAMPLES/portable-models/LennardJones_Ar -# kim-api-collections-management install system $KIM_API_EXAMPLES/portable-models/ex_model_Ar_P_LJ -# kim-api-collections-management install system $KIM_API_EXAMPLES/portable-models/LennardJones612_UniversalShifted__MO_959249795837_003 -# kim-api-collections-management install system $KIM_API_EXAMPLES/simulator-models/Sim_LAMMPS_LJcut_AkersonElliott_Alchemy_PbAu + + kim-api-collections-management install system $KIM_API_EXAMPLES/model-drivers/LennardJones612__MD_414112407348_003 + kim-api-collections-management install system $KIM_API_EXAMPLES/model-drivers/ex_model_driver_P_LJ + kim-api-collections-management install system $KIM_API_EXAMPLES/portable-models/LennardJones_Ar + kim-api-collections-management install system $KIM_API_EXAMPLES/portable-models/ex_model_Ar_P_LJ + kim-api-collections-management install system $KIM_API_EXAMPLES/portable-models/LennardJones612_UniversalShifted__MO_959249795837_003 + kim-api-collections-management install system $KIM_API_EXAMPLES/simulator-models/Sim_LAMMPS_LJcut_AkersonElliott_Alchemy_PbAu ########################################################################### From 0a8b4c514265c478d219876b75cc90ade4ea3677 Mon Sep 17 00:00:00 2001 From: Lenz Fiedler Date: Wed, 25 May 2022 15:27:27 +0200 Subject: [PATCH 209/585] Hotfix for triclinic calculations --- src/compute_grid_local.cpp | 36 ++++++++++++++++++++++++++++++------ src/compute_grid_local.h | 1 + 2 files changed, 31 insertions(+), 6 deletions(-) diff --git a/src/compute_grid_local.cpp b/src/compute_grid_local.cpp index a6f3cf29ad..504555a718 100644 --- a/src/compute_grid_local.cpp +++ b/src/compute_grid_local.cpp @@ -85,7 +85,6 @@ void ComputeGridLocal::setup() /* ---------------------------------------------------------------------- convert global array indexes to box coords - for triclinic, these will be lamda coords ------------------------------------------------------------------------- */ void ComputeGridLocal::grid2x(int ix, int iy, int iz, double *x) @@ -93,8 +92,23 @@ void ComputeGridLocal::grid2x(int ix, int iy, int iz, double *x) x[0] = ix*delx; x[1] = iy*dely; x[2] = iz*delz; + + if (triclinic) domain->lamda2x(x, x); } +/* ---------------------------------------------------------------------- + convert global array indexes to lamda coords; for orthorombic + cells defaults to grid2x. +------------------------------------------------------------------------- */ + +void ComputeGridLocal::grid2lamda(int ix, int iy, int iz, double *x) +{ + x[0] = ix*delx; + x[1] = iy*dely; + x[2] = iz*delz; +} + + /* ---------------------------------------------------------------------- create arrays ------------------------------------------------------------------------- */ @@ -240,9 +254,20 @@ void ComputeGridLocal::assign_coords() alocal[igrid][1] = iy; alocal[igrid][2] = iz; double xgrid[3]; - grid2x(ix, iy, iz, xgrid); - // ensure gridpoint is not strictly outside subdomain + // For triclinic: create gridpoint in lamda coordinates and transform after check. + // For orthorombic: create gridpoint in box coordinates. + + if (triclinic) + { + grid2lamda(ix, iy, iz, xgrid); + } + else + { + grid2x(ix, iy, iz, xgrid); + } + + // Ensure gridpoint is not strictly outside subdomain. // There have been some problem with a gridpoint being something like 2e-17 outside of the subdomain, // thus the EPISLON check. if ((sublo[0]-xgrid[0]) > EPSILON || (xgrid[0]-subhi[0]) > EPSILON || @@ -252,11 +277,10 @@ void ComputeGridLocal::assign_coords() error->one(FLERR,"Invalid gridpoint position in compute grid/local"); } - // convert lamda to x, y, z, after sudomain check - + if (triclinic) domain->lamda2x(xgrid, xgrid); - + alocal[igrid][3] = xgrid[0]; alocal[igrid][4] = xgrid[1]; alocal[igrid][5] = xgrid[2]; diff --git a/src/compute_grid_local.h b/src/compute_grid_local.h index b3d2f4cd94..79a5ea765d 100644 --- a/src/compute_grid_local.h +++ b/src/compute_grid_local.h @@ -49,6 +49,7 @@ class ComputeGridLocal : public Compute { void allocate(); // create arrays void deallocate(); // free arrays void grid2x(int, int, int, double*); // convert global indices to coordinates + void grid2lamda(int, int, int, double*); // convert global indices to lamda coordinates void set_grid_global(); // set global grid void set_grid_local(); // set bounds for local grid void assign_coords(); // assign coords for grid From f6680861a087e3b7b36eba1af31e7c2ceaf219fe Mon Sep 17 00:00:00 2001 From: Yury Lysogorskiy Date: Wed, 25 May 2022 17:27:12 +0200 Subject: [PATCH 210/585] BUGFIX: bad array length: initialize maximum number of neighbours with max_jnum=0 --- src/ML-PACE/pair_pace.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/ML-PACE/pair_pace.cpp b/src/ML-PACE/pair_pace.cpp index 11e8a659a5..199bfe64ab 100644 --- a/src/ML-PACE/pair_pace.cpp +++ b/src/ML-PACE/pair_pace.cpp @@ -155,7 +155,7 @@ void PairPACE::compute(int eflag, int vflag) // they are disregarded anyway //determine the maximum number of neighbours - int max_jnum = -1; + int max_jnum = 0; int nei = 0; for (ii = 0; ii < list->inum; ii++) { i = ilist[ii]; From 2085c10002e1924f2a4f84ac51a2983a3bd11f41 Mon Sep 17 00:00:00 2001 From: Yury Lysogorskiy Date: Wed, 25 May 2022 17:56:24 +0200 Subject: [PATCH 211/585] update version of lib-pace to v.2021.10.25.fix2 --- cmake/Modules/Packages/ML-PACE.cmake | 4 ++-- lib/pace/Install.py | 5 +++-- 2 files changed, 5 insertions(+), 4 deletions(-) diff --git a/cmake/Modules/Packages/ML-PACE.cmake b/cmake/Modules/Packages/ML-PACE.cmake index 9f25c9baa1..04ddeed6f2 100644 --- a/cmake/Modules/Packages/ML-PACE.cmake +++ b/cmake/Modules/Packages/ML-PACE.cmake @@ -1,6 +1,6 @@ -set(PACELIB_URL "https://github.com/ICAMS/lammps-user-pace/archive/refs/tags/v.2021.10.25.fix.tar.gz" CACHE STRING "URL for PACE evaluator library sources") +set(PACELIB_URL "https://github.com/ICAMS/lammps-user-pace/archive/refs/tags/v.2021.10.25.fix2.tar.gz" CACHE STRING "URL for PACE evaluator library sources") -set(PACELIB_MD5 "e0572de57039d4afedefb25707b6ceae" CACHE STRING "MD5 checksum of PACE evaluator library tarball") +set(PACELIB_MD5 "d1984c9d5bf88715fc20b23dcf95aa12" CACHE STRING "MD5 checksum of PACE evaluator library tarball") mark_as_advanced(PACELIB_URL) mark_as_advanced(PACELIB_MD5) diff --git a/lib/pace/Install.py b/lib/pace/Install.py index c59c249657..165b90774e 100644 --- a/lib/pace/Install.py +++ b/lib/pace/Install.py @@ -15,7 +15,7 @@ from install_helpers import fullpath, geturl, checkmd5sum # settings thisdir = fullpath('.') -version = 'v.2021.10.25.fix' +version = 'v.2021.10.25.fix2' # known checksums for different PACE versions. used to validate the download. checksums = { \ @@ -23,7 +23,8 @@ checksums = { \ 'v.2021.4.9' : '4db54962fbd6adcf8c18d46e1798ceb5', 'v.2021.9.28' : 'f98363bb98adc7295ea63974738c2a1b', 'v.2021.10.25' : 'a2ac3315c41a1a4a5c912bcb1bc9c5cc', - 'v.2021.10.25.fix': 'e0572de57039d4afedefb25707b6ceae' + 'v.2021.10.25.fix': 'e0572de57039d4afedefb25707b6ceae', + 'v.2021.10.25.fix2': 'd1984c9d5bf88715fc20b23dcf95aa12' } From 1ae62793ebeb62182452935ca45b6e1586c416f0 Mon Sep 17 00:00:00 2001 From: Christoph Scherer Date: Thu, 26 May 2022 13:12:50 +0200 Subject: [PATCH 212/585] src/MANYBODY/pair_sw.h: made read_file(char *) virtual to allow overriding --- src/MANYBODY/pair_sw.h | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/MANYBODY/pair_sw.h b/src/MANYBODY/pair_sw.h index 84088926b1..8bae7e5282 100644 --- a/src/MANYBODY/pair_sw.h +++ b/src/MANYBODY/pair_sw.h @@ -55,7 +55,7 @@ class PairSW : public Pair { void settings(int, char **) override; virtual void allocate(); - void read_file(char *); + virtual void read_file(char *); virtual void setup_params(); void twobody(Param *, double, double &, int, double &); virtual void threebody(Param *, Param *, Param *, double, double, double *, double *, double *, From 1cfba3d8bbdd418d06c86a01e955e9d678645ea8 Mon Sep 17 00:00:00 2001 From: Christoph Scherer Date: Thu, 26 May 2022 13:21:47 +0200 Subject: [PATCH 213/585] src/MANYBODY/pair_sw_3b_table.h, src/MANYBODY/pair_sw_3b_table.cpp: added pair style sw/3b/table which is a modification of the SW pair style with tabulated angular potentials --- src/MANYBODY/pair_sw_3b_table.cpp | 783 ++++++++++++++++++++++++++++++ src/MANYBODY/pair_sw_3b_table.h | 127 +++++ 2 files changed, 910 insertions(+) create mode 100644 src/MANYBODY/pair_sw_3b_table.cpp create mode 100644 src/MANYBODY/pair_sw_3b_table.h diff --git a/src/MANYBODY/pair_sw_3b_table.cpp b/src/MANYBODY/pair_sw_3b_table.cpp new file mode 100644 index 0000000000..d9ef723123 --- /dev/null +++ b/src/MANYBODY/pair_sw_3b_table.cpp @@ -0,0 +1,783 @@ +// clang-format off +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + https://www.lammps.org/, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +/* ---------------------------------------------------------------------- + Contributing author: Christoph Scherer (MPIP Mainz) + scherer@mpip-mainz.mpg.de +------------------------------------------------------------------------- */ + +#include "pair_sw_3b_table.h" + +#include "atom.h" +#include "comm.h" +#include "error.h" +#include "force.h" +#include "math_const.h" +#include "memory.h" +#include "neigh_list.h" +#include "neighbor.h" +#include "table_file_reader.h" +#include "potential_file_reader.h" + +#include +#include + + +using namespace LAMMPS_NS; + +using MathConst::DEG2RAD; +using MathConst::MY_PI; +using MathConst::RAD2DEG; + +#define DELTA 4 + +enum { LINEAR, SPLINE }; + +#define SMALL 0.001 +#define TINY 1.E-10 + +/* ---------------------------------------------------------------------- */ + +PairSW3BTable::PairSW3BTable(LAMMPS *lmp) : PairSW(lmp) +{ + single_enable = 0; + restartinfo = 0; + one_coeff = 1; + manybody_flag = 1; + centroidstressflag = CENTROID_NOTAVAIL; + unit_convert_flag = utils::get_supported_conversions(utils::ENERGY); + + params = nullptr; + extended_params = nullptr; + + maxshort = 10; + neighshort = nullptr; +} + +/* ---------------------------------------------------------------------- + check if allocated, since class can be destructed when incomplete +------------------------------------------------------------------------- */ + +PairSW3BTable::~PairSW3BTable() +{ + if (copymode) return; + + for (int m = 0; m < nparams; m++) free_param(&extended_params[m]); // free_param will call free_table + memory->destroy(params); + memory->destroy(extended_params); + memory->destroy(elem3param); + + if (allocated) { + memory->destroy(setflag); + memory->destroy(cutsq); + memory->destroy(neighshort); + } +} + +/* ---------------------------------------------------------------------- */ + +void PairSW3BTable::compute(int eflag, int vflag) +{ + int i,j,k,ii,jj,kk,inum,jnum,jnumm1; + int itype,jtype,ktype,ijparam,ikparam,ijkparam; + tagint itag,jtag; + double xtmp,ytmp,ztmp,delx,dely,delz,evdwl,fpair; + double rsq,rsq1,rsq2; + double delr1[3],delr2[3],fj[3],fk[3]; + int *ilist,*jlist,*numneigh,**firstneigh; + + evdwl = 0.0; + ev_init(eflag,vflag); + + double **x = atom->x; + double **f = atom->f; + tagint *tag = atom->tag; + int *type = atom->type; + int nlocal = atom->nlocal; + int newton_pair = force->newton_pair; + + inum = list->inum; + ilist = list->ilist; + numneigh = list->numneigh; + firstneigh = list->firstneigh; + + double fxtmp,fytmp,fztmp; + + // loop over full neighbor list of my atoms + + for (ii = 0; ii < inum; ii++) { + i = ilist[ii]; + itag = tag[i]; + itype = map[type[i]]; + xtmp = x[i][0]; + ytmp = x[i][1]; + ztmp = x[i][2]; + fxtmp = fytmp = fztmp = 0.0; + + // two-body interactions, skip half of them + + jlist = firstneigh[i]; + jnum = numneigh[i]; + int numshort = 0; + + for (jj = 0; jj < jnum; jj++) { + j = jlist[jj]; + j &= NEIGHMASK; + + delx = xtmp - x[j][0]; + dely = ytmp - x[j][1]; + delz = ztmp - x[j][2]; + rsq = delx*delx + dely*dely + delz*delz; + + jtype = map[type[j]]; + ijparam = elem3param[itype][jtype][jtype]; + if (rsq >= params[ijparam].cutsq) { + continue; + } else { + neighshort[numshort++] = j; + if (numshort >= maxshort) { + maxshort += maxshort/2; + memory->grow(neighshort,maxshort,"pair:neighshort"); + } + } + + jtag = tag[j]; + if (itag > jtag) { + if ((itag+jtag) % 2 == 0) continue; + } else if (itag < jtag) { + if ((itag+jtag) % 2 == 1) continue; + } else { + if (x[j][2] < ztmp) continue; + if (x[j][2] == ztmp && x[j][1] < ytmp) continue; + if (x[j][2] == ztmp && x[j][1] == ytmp && x[j][0] < xtmp) continue; + } + + twobody(¶ms[ijparam],rsq,fpair,eflag,evdwl); + + fxtmp += delx*fpair; + fytmp += dely*fpair; + fztmp += delz*fpair; + f[j][0] -= delx*fpair; + f[j][1] -= dely*fpair; + f[j][2] -= delz*fpair; + + if (evflag) ev_tally(i,j,nlocal,newton_pair, + evdwl,0.0,fpair,delx,dely,delz); + } + + jnumm1 = numshort - 1; + + for (jj = 0; jj < jnumm1; jj++) { + j = neighshort[jj]; + jtype = map[type[j]]; + ijparam = elem3param[itype][jtype][jtype]; + delr1[0] = x[j][0] - xtmp; + delr1[1] = x[j][1] - ytmp; + delr1[2] = x[j][2] - ztmp; + rsq1 = delr1[0]*delr1[0] + delr1[1]*delr1[1] + delr1[2]*delr1[2]; + + double fjxtmp,fjytmp,fjztmp; + fjxtmp = fjytmp = fjztmp = 0.0; + + for (kk = jj+1; kk < numshort; kk++) { + k = neighshort[kk]; + ktype = map[type[k]]; + ikparam = elem3param[itype][ktype][ktype]; + ijkparam = elem3param[itype][jtype][ktype]; + + delr2[0] = x[k][0] - xtmp; + delr2[1] = x[k][1] - ytmp; + delr2[2] = x[k][2] - ztmp; + rsq2 = delr2[0]*delr2[0] + delr2[1]*delr2[1] + delr2[2]*delr2[2]; + + threebody(¶ms[ijparam],¶ms[ikparam],¶ms[ijkparam], &extended_params[ijkparam], + rsq1,rsq2,delr1,delr2,fj,fk,eflag,evdwl); + + fxtmp -= fj[0] + fk[0]; + fytmp -= fj[1] + fk[1]; + fztmp -= fj[2] + fk[2]; + fjxtmp += fj[0]; + fjytmp += fj[1]; + fjztmp += fj[2]; + f[k][0] += fk[0]; + f[k][1] += fk[1]; + f[k][2] += fk[2]; + + if (evflag) ev_tally3(i,j,k,evdwl,0.0,fj,fk,delr1,delr2); + } + f[j][0] += fjxtmp; + f[j][1] += fjytmp; + f[j][2] += fjztmp; + } + f[i][0] += fxtmp; + f[i][1] += fytmp; + f[i][2] += fztmp; + } + + if (vflag_fdotr) virial_fdotr_compute(); +} + +/* ---------------------------------------------------------------------- */ + +void PairSW3BTable::read_file(char *file) +{ + memory->sfree(params); + params = nullptr; + memory->sfree(extended_params); + extended_params = nullptr; + nparams = maxparam = 0; + + // open file on proc 0 + + if (comm->me == 0) { + PotentialFileReader reader(lmp, file, "sw", unit_convert_flag); + char *line; + + // transparently convert units for supported conversions + + int unit_convert = reader.get_unit_convert(); + double conversion_factor = utils::get_conversion_factor(utils::ENERGY, + unit_convert); + + while ((line = reader.next_line(NPARAMS_PER_LINE))) { + try { + ValueTokenizer values(line); + + std::string iname = values.next_string(); + std::string jname = values.next_string(); + std::string kname = values.next_string(); + + // ielement,jelement,kelement = 1st args + // if all 3 args are in element list, then parse this line + // else skip to next entry in file + int ielement, jelement, kelement; + + for (ielement = 0; ielement < nelements; ielement++) + if (iname == elements[ielement]) break; + if (ielement == nelements) continue; + for (jelement = 0; jelement < nelements; jelement++) + if (jname == elements[jelement]) break; + if (jelement == nelements) continue; + for (kelement = 0; kelement < nelements; kelement++) + if (kname == elements[kelement]) break; + if (kelement == nelements) continue; + + // load up parameter settings and error check their values + + if (nparams == maxparam) { + maxparam += DELTA; + params = (Param *) memory->srealloc(params,maxparam*sizeof(Param), + "pair:params"); + extended_params = (Param_Extension *) memory->srealloc(extended_params,maxparam*sizeof(Param_Extension), + "pair:extended_params"); + + // make certain all addional allocated storage is initialized + // to avoid false positives when checking with valgrind + + memset(params + nparams, 0, DELTA*sizeof(Param)); + } + + params[nparams].ielement = ielement; + params[nparams].jelement = jelement; + params[nparams].kelement = kelement; + params[nparams].epsilon = values.next_double(); + params[nparams].sigma = values.next_double(); + params[nparams].littlea = values.next_double(); + params[nparams].lambda = values.next_double(); + params[nparams].gamma = values.next_double(); + params[nparams].costheta = values.next_double(); + params[nparams].biga = values.next_double(); + params[nparams].bigb = values.next_double(); + params[nparams].powerp = values.next_double(); + params[nparams].powerq = values.next_double(); + params[nparams].tol = values.next_double(); + + // read parameters of angle table + std::string tablename_string = values.next_string(); + extended_params[nparams].tablenamelength = tablename_string.length()+1; + memory->create(extended_params[nparams].tablename, extended_params[nparams].tablenamelength, "extended_params.tablename"); + for (int x = 0; x < extended_params[nparams].tablenamelength; ++x) { + extended_params[nparams].tablename[x] = tablename_string[x]; + } + std::string keyword_string = values.next_string(); + extended_params[nparams].keywordlength = keyword_string.length()+1; + memory->create(extended_params[nparams].keyword, extended_params[nparams].keywordlength, "extended_params.keyword"); + for (int x = 0; x < extended_params[nparams].keywordlength; ++x) { + extended_params[nparams].keyword[x] = keyword_string[x]; + } + std::string tablestyle_string = values.next_string(); + char *tablestyle; + memory->create(tablestyle, (tablestyle_string.length()+1), "tablestyle"); + for (int x = 0; x < (tablestyle_string.length()+1); ++x) { + tablestyle[x] = tablestyle_string[x]; + } + if (strcmp(tablestyle,"linear") == 0) extended_params[nparams].tabstyle = LINEAR; + else if (strcmp(tablestyle,"spline") == 0) extended_params[nparams].tabstyle = SPLINE; + else error->all(FLERR,"Unknown table style of angle table file"); + extended_params[nparams].tablength = values.next_int(); + + } catch (TokenizerException &e) { + error->one(FLERR, e.what()); + } + + if (unit_convert) { + params[nparams].epsilon *= conversion_factor; + } + + if (params[nparams].epsilon < 0.0 || params[nparams].sigma < 0.0 || + params[nparams].littlea < 0.0 || params[nparams].lambda < 0.0 || + params[nparams].gamma < 0.0 || params[nparams].biga < 0.0 || + params[nparams].bigb < 0.0 || params[nparams].powerp < 0.0 || + params[nparams].powerq < 0.0 || params[nparams].tol < 0.0 || + extended_params[nparams].tabstyle < 0.0 || extended_params[nparams].tablength < 0.0) + error->one(FLERR,"Illegal Stillinger-Weber parameter"); + + nparams++; + } + } + + MPI_Bcast(&nparams, 1, MPI_INT, 0, world); + MPI_Bcast(&maxparam, 1, MPI_INT, 0, world); + + if (comm->me != 0) { + params = (Param *) memory->srealloc(params,maxparam*sizeof(Param), "pair:params"); + extended_params = (Param_Extension *) memory->srealloc(extended_params,maxparam*sizeof(Param_Extension), "pair:extended_params"); + } + + MPI_Bcast(params, maxparam*sizeof(Param), MPI_BYTE, 0, world); + MPI_Bcast(extended_params, maxparam*sizeof(Param_Extension), MPI_BYTE, 0, world); + + // for each set of parameters, broadcast table name and keyword and read angle table + for (int m = 0; m < nparams; ++m){ + if (comm->me != 0) { + memory->create(extended_params[m].tablename, extended_params[m].tablenamelength, "extended_params.tablename"); + } + MPI_Bcast(&extended_params[m].tablename, extended_params[m].tablenamelength, MPI_CHAR, 0, world); + if (comm->me != 0) { + memory->create(extended_params[m].keyword, extended_params[m].keywordlength, "extended_params.keyword"); + } + MPI_Bcast(&extended_params[m].keyword, extended_params[m].keywordlength, MPI_CHAR, 0, world); + + // initialize angtable + memory->create(extended_params[m].angtable,1,"extended_params:angtable"); + null_table(extended_params[m].angtable); + + // call read_table to read corresponding tabulated angle file (only called by process 0) + if (comm->me == 0) read_table(extended_params[m].angtable,extended_params[m].tablename,extended_params[m].keyword); + + // broadcast read in angtable to all processes + bcast_table(extended_params[m].angtable); + + // the following table manipulations are done in all processes + // error check on table parameters + if (extended_params[m].angtable->ninput <= 1) error->one(FLERR,"Invalid angle table length"); + + // error check on parameter range of angle table + double alo,ahi; + alo = extended_params[m].angtable->afile[0]; + ahi = extended_params[m].angtable->afile[extended_params[m].angtable->ninput-1]; + if (fabs(alo-0.0) > TINY || fabs(ahi-180.0) > TINY) + error->all(FLERR,"Angle table must range from 0 to 180 degrees"); + + // convert theta from degrees to radians + for (int i = 0; i < extended_params[m].angtable->ninput; ++i){ + extended_params[m].angtable->afile[i] *= MY_PI/180.0; + extended_params[m].angtable->ffile[i] *= 180.0/MY_PI; + } + + // spline read-in table and compute a,e,f vectors within table + spline_table(extended_params[m].angtable); + // compute_table needs parameter params[m].length for this specific interaction as + // read in value length from .sw file can be different from value in angle table file + compute_table(extended_params[m].angtable,extended_params[m].tablength); + } +} + +/* ---------------------------------------------------------------------- */ + +void PairSW3BTable::threebody(Param *paramij, Param *paramik, Param *paramijk, Param_Extension *extended_paramijk, + double rsq1, double rsq2, + double *delr1, double *delr2, + double *fj, double *fk, int eflag, double &eng) +{ + double r1,rinvsq1,rainv1,gsrainv1,gsrainvsq1,expgsrainv1; + double r2,rinvsq2,rainv2,gsrainv2,gsrainvsq2,expgsrainv2; + double rinv12,cs,facexp; + double ftheta,facradtable,frad1table,frad2table,var; + double acosprime,gradj1,gradj2,gradk1,gradk2,fprimetheta; + + r1 = sqrt(rsq1); + rinvsq1 = 1.0/rsq1; + rainv1 = 1.0/(r1 - paramij->cut); + gsrainv1 = paramij->sigma_gamma * rainv1; + gsrainvsq1 = gsrainv1*rainv1/r1; + expgsrainv1 = exp(gsrainv1); + + r2 = sqrt(rsq2); + rinvsq2 = 1.0/rsq2; + rainv2 = 1.0/(r2 - paramik->cut); + gsrainv2 = paramik->sigma_gamma * rainv2; + gsrainvsq2 = gsrainv2*rainv2/r2; + expgsrainv2 = exp(gsrainv2); + + facexp = expgsrainv1*expgsrainv2; + + rinv12 = 1.0/(r1*r2); + cs = (delr1[0]*delr2[0] + delr1[1]*delr2[1] + delr1[2]*delr2[2]) * rinv12; + + var = acos(cs); + + // look up energy (f(theta), ftheta) and force (df(theta)/dtheta, fprimetheta) at + // angle theta (var) in angle table belonging to parameter set paramijk + uf_lookup(extended_paramijk, var, ftheta, fprimetheta); + + acosprime = 1.0 / (sqrt(1 - cs*cs ) ); + + facradtable = facexp*ftheta; + frad1table = facradtable*gsrainvsq1; + frad2table = facradtable*gsrainvsq2; + gradj1 = acosprime * cs * rinvsq1 * facexp * fprimetheta; + gradj2 = acosprime * rinv12 * facexp * fprimetheta; + gradk1 = acosprime * cs * rinvsq2 * facexp * fprimetheta; + gradk2 = acosprime * rinv12 * facexp * fprimetheta; + + fj[0] = delr1[0]*(frad1table+gradj1)-delr2[0]*gradj2; + fj[1] = delr1[1]*(frad1table+gradj1)-delr2[1]*gradj2; + fj[2] = delr1[2]*(frad1table+gradj1)-delr2[2]*gradj2; + + fk[0] = delr2[0]*(frad2table+gradk1)-delr1[0]*gradk2; + fk[1] = delr2[1]*(frad2table+gradk1)-delr1[1]*gradk2; + fk[2] = delr2[2]*(frad2table+gradk1)-delr1[2]*gradk2; + + if (eflag) eng = facradtable; +} + +/* ---------------------------------------------------------------------- + read table file, only called by proc 0 +------------------------------------------------------------------------- */ + +void PairSW3BTable::read_table(Table *tb, char *file, char *keyword) +{ + TableFileReader reader(lmp, file, "angle"); + + char *line = reader.find_section_start(keyword); + + if (!line) { error->one(FLERR, "Did not find keyword in table file"); } + + // read args on 2nd line of section + // allocate table arrays for file values + + line = reader.next_line(); + param_extract(tb, line); + memory->create(tb->afile, tb->ninput, "angle:afile"); + memory->create(tb->efile, tb->ninput, "angle:efile"); + memory->create(tb->ffile, tb->ninput, "angle:ffile"); + + // read a,e,f table values from file + + int cerror = 0; + reader.skip_line(); + for (int i = 0; i < tb->ninput; i++) { + line = reader.next_line(4); + try { + ValueTokenizer values(line); + values.next_int(); + tb->afile[i] = values.next_double(); + tb->efile[i] = values.next_double(); + tb->ffile[i] = values.next_double(); + } catch (TokenizerException &) { + ++cerror; + } + } + + // warn if data was read incompletely, e.g. columns were missing + + if (cerror) + error->warning(FLERR, "{} of {} lines in table incomplete or could not be parsed", cerror, + tb->ninput); +} + +/* ---------------------------------------------------------------------- + build spline representation of e,f over entire range of read-in table + this function sets these values in e2file,f2file +------------------------------------------------------------------------- */ + +void PairSW3BTable::spline_table(Table *tb) +{ + memory->create(tb->e2file, tb->ninput, "angle:e2file"); + memory->create(tb->f2file, tb->ninput, "angle:f2file"); + + double ep0 = -tb->ffile[0]; + double epn = -tb->ffile[tb->ninput - 1]; + spline(tb->afile, tb->efile, tb->ninput, ep0, epn, tb->e2file); + + if (tb->fpflag == 0) { + tb->fplo = (tb->ffile[1] - tb->ffile[0]) / (tb->afile[1] - tb->afile[0]); + tb->fphi = (tb->ffile[tb->ninput - 1] - tb->ffile[tb->ninput - 2]) / + (tb->afile[tb->ninput - 1] - tb->afile[tb->ninput - 2]); + } + + double fp0 = tb->fplo; + double fpn = tb->fphi; + spline(tb->afile, tb->ffile, tb->ninput, fp0, fpn, tb->f2file); +} + +/* ---------------------------------------------------------------------- + compute a,e,f vectors from splined values +------------------------------------------------------------------------- */ + +void PairSW3BTable::compute_table(Table *tb,int length) +{ + // delta = table spacing in angle for N-1 bins + + int tlm1 = length - 1; + tb->delta = MY_PI / tlm1; + tb->invdelta = 1.0 / tb->delta; + tb->deltasq6 = tb->delta * tb->delta / 6.0; + + // N-1 evenly spaced bins in angle from 0 to PI + // ang,e,f = value at lower edge of bin + // de,df values = delta values of e,f + // ang,e,f are N in length so de,df arrays can compute difference + + memory->create(tb->ang, length, "angle:ang"); + memory->create(tb->e, length, "angle:e"); + memory->create(tb->de, length, "angle:de"); + memory->create(tb->f, length, "angle:f"); + memory->create(tb->df, length, "angle:df"); + memory->create(tb->e2, length, "angle:e2"); + memory->create(tb->f2, length, "angle:f2"); + + double a; + for (int i = 0; i < length; i++) { + a = i * tb->delta; + tb->ang[i] = a; + tb->e[i] = splint(tb->afile, tb->efile, tb->e2file, tb->ninput, a); + tb->f[i] = splint(tb->afile, tb->ffile, tb->f2file, tb->ninput, a); + } + + for (int i = 0; i < tlm1; i++) { + tb->de[i] = tb->e[i + 1] - tb->e[i]; + tb->df[i] = tb->f[i + 1] - tb->f[i]; + } + // get final elements from linear extrapolation + tb->de[tlm1] = 2.0 * tb->de[tlm1 - 1] - tb->de[tlm1 - 2]; + tb->df[tlm1] = 2.0 * tb->df[tlm1 - 1] - tb->df[tlm1 - 2]; + + double ep0 = -tb->f[0]; + double epn = -tb->f[tlm1]; + spline(tb->ang, tb->e, length, ep0, epn, tb->e2); + spline(tb->ang, tb->f, length, tb->fplo, tb->fphi, tb->f2); +} + +/* ---------------------------------------------------------------------- + broadcast read-in table info from proc 0 to other procs + this function communicates these values in Table: + ninput,afile,efile,ffile,fpflag,fplo,fphi,theta0 +------------------------------------------------------------------------- */ + +void PairSW3BTable::bcast_table(Table *tb) +{ + MPI_Bcast(&tb->ninput, 1, MPI_INT, 0, world); + + int me; + MPI_Comm_rank(world, &me); + if (me > 0) { + memory->create(tb->afile, tb->ninput, "angle:afile"); + memory->create(tb->efile, tb->ninput, "angle:efile"); + memory->create(tb->ffile, tb->ninput, "angle:ffile"); + } + + MPI_Bcast(tb->afile, tb->ninput, MPI_DOUBLE, 0, world); + MPI_Bcast(tb->efile, tb->ninput, MPI_DOUBLE, 0, world); + MPI_Bcast(tb->ffile, tb->ninput, MPI_DOUBLE, 0, world); + + MPI_Bcast(&tb->fpflag, 1, MPI_INT, 0, world); + if (tb->fpflag) { + MPI_Bcast(&tb->fplo, 1, MPI_DOUBLE, 0, world); + MPI_Bcast(&tb->fphi, 1, MPI_DOUBLE, 0, world); + } + MPI_Bcast(&tb->theta0, 1, MPI_DOUBLE, 0, world); +} + +/* ---------------------------------------------------------------------- */ + +void PairSW3BTable::null_table(Table *tb) +{ + tb->afile = tb->efile = tb->ffile = nullptr; + tb->e2file = tb->f2file = nullptr; + tb->ang = tb->e = tb->de = nullptr; + tb->f = tb->df = tb->e2 = tb->f2 = nullptr; +} + +/* ---------------------------------------------------------------------- */ + +void PairSW3BTable::free_table(Table *tb) +{ + memory->destroy(tb->afile); + memory->destroy(tb->efile); + memory->destroy(tb->ffile); + memory->destroy(tb->e2file); + memory->destroy(tb->f2file); + + memory->destroy(tb->ang); + memory->destroy(tb->e); + memory->destroy(tb->de); + memory->destroy(tb->f); + memory->destroy(tb->df); + memory->destroy(tb->e2); + memory->destroy(tb->f2); +} + +/* ---------------------------------------------------------------------- */ + +void PairSW3BTable::free_param(Param_Extension *pm) +{ + // call free_table to destroy associated angle table + free_table(pm->angtable); + // then destroy associated angle table + memory->sfree(pm->angtable); +} + +/* ---------------------------------------------------------------------- + extract attributes from parameter line in table section + format of line: N value FP fplo fphi EQ theta0 + N is required, other params are optional + + only called by read_table, only called by proc 0 +------------------------------------------------------------------------- */ + +void PairSW3BTable::param_extract(Table *tb, char *line) +{ + tb->ninput = 0; + tb->fpflag = 0; + tb->theta0 = MY_PI; + + try { + ValueTokenizer values(line); + + while (values.has_next()) { + std::string word = values.next_string(); + + if (word == "N") { + tb->ninput = values.next_int(); + } else if (word == "FP") { + tb->fpflag = 1; + tb->fplo = values.next_double(); + tb->fphi = values.next_double(); + tb->fplo *= RAD2DEG * RAD2DEG; + tb->fphi *= RAD2DEG * RAD2DEG; + } else if (word == "EQ") { + tb->theta0 = DEG2RAD * values.next_double(); + } else { + error->one(FLERR, "Invalid keyword in angle table parameters"); + } + } + } catch (TokenizerException &e) { + error->one(FLERR, e.what()); + } + + if (tb->ninput == 0) error->one(FLERR, "Angle table parameters did not set N"); +} + +/* ---------------------------------------------------------------------- + spline and splint routines modified from Numerical Recipes +------------------------------------------------------------------------- */ + +void PairSW3BTable::spline(double *x, double *y, int n, double yp1, double ypn, double *y2) +{ + int i, k; + double p, qn, sig, un; + double *u = new double[n]; + + if (yp1 > 0.99e300) + y2[0] = u[0] = 0.0; + else { + y2[0] = -0.5; + u[0] = (3.0 / (x[1] - x[0])) * ((y[1] - y[0]) / (x[1] - x[0]) - yp1); + } + for (i = 1; i < n - 1; i++) { + sig = (x[i] - x[i - 1]) / (x[i + 1] - x[i - 1]); + p = sig * y2[i - 1] + 2.0; + y2[i] = (sig - 1.0) / p; + u[i] = (y[i + 1] - y[i]) / (x[i + 1] - x[i]) - (y[i] - y[i - 1]) / (x[i] - x[i - 1]); + u[i] = (6.0 * u[i] / (x[i + 1] - x[i - 1]) - sig * u[i - 1]) / p; + } + if (ypn > 0.99e300) + qn = un = 0.0; + else { + qn = 0.5; + un = (3.0 / (x[n - 1] - x[n - 2])) * (ypn - (y[n - 1] - y[n - 2]) / (x[n - 1] - x[n - 2])); + } + y2[n - 1] = (un - qn * u[n - 2]) / (qn * y2[n - 2] + 1.0); + for (k = n - 2; k >= 0; k--) y2[k] = y2[k] * y2[k + 1] + u[k]; + + delete[] u; +} +/* ---------------------------------------------------------------------- */ + +double PairSW3BTable::splint(double *xa, double *ya, double *y2a, int n, double x) +{ + int klo, khi, k; + double h, b, a, y; + + klo = 0; + khi = n - 1; + while (khi - klo > 1) { + k = (khi + klo) >> 1; + if (xa[k] > x) + khi = k; + else + klo = k; + } + h = xa[khi] - xa[klo]; + a = (xa[khi] - x) / h; + b = (x - xa[klo]) / h; + y = a * ya[klo] + b * ya[khi] + + ((a * a * a - a) * y2a[klo] + (b * b * b - b) * y2a[khi]) * (h * h) / 6.0; + return y; +} + +/* ---------------------------------------------------------------------- + calculate potential u and force f at angle x +------------------------------------------------------------------------- */ + +void PairSW3BTable::uf_lookup(Param_Extension *pm, double x, double &u, double &f) +{ + if (!std::isfinite(x)) { error->one(FLERR, "Illegal angle in angle style table"); } + + double fraction,a,b; + + // invdelta is based on tablength-1 + int itable = static_cast(x * pm->angtable->invdelta); + if (itable < 0) itable = 0; + if (itable >= pm->tablength) itable = pm->tablength - 1; + + if (pm->tabstyle == LINEAR) { + fraction = (x - pm->angtable->ang[itable]) * pm->angtable->invdelta; + u = pm->angtable->e[itable] + fraction*pm->angtable->de[itable]; + f = pm->angtable->f[itable] + fraction*pm->angtable->df[itable]; + } else if (pm->tabstyle == SPLINE) { + fraction = (x - pm->angtable->ang[itable]) * pm->angtable->invdelta; + + b = (x - pm->angtable->ang[itable]) * pm->angtable->invdelta; + a = 1.0 - b; + u = a * pm->angtable->e[itable] + b * pm->angtable->e[itable+1] + + ((a * a * a - a) * pm->angtable->e2[itable] + (b * b * b - b) * pm->angtable->e2[itable+1]) * + pm->angtable->deltasq6; + f = a * pm->angtable->f[itable] + b * pm->angtable->f[itable+1] + + ((a * a * a - a) * pm->angtable->f2[itable] + (b * b * b - b) * pm->angtable->f2[itable+1]) * + pm->angtable->deltasq6; + } +} diff --git a/src/MANYBODY/pair_sw_3b_table.h b/src/MANYBODY/pair_sw_3b_table.h new file mode 100644 index 0000000000..3f537d432c --- /dev/null +++ b/src/MANYBODY/pair_sw_3b_table.h @@ -0,0 +1,127 @@ +/* -*- c++ -*- ---------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + https://www.lammps.org/, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#ifdef PAIR_CLASS +// clang-format off +PairStyle(sw/3b/table,PairSW3BTable); +// clang-format on +#else + +#ifndef LMP_PAIR_SW_3B_TABLE_H +#define LMP_PAIR_SW_3B_TABLE_H + +#include "pair_sw.h" + +namespace LAMMPS_NS { + +class PairSW3BTable : public PairSW { + public: + PairSW3BTable(class LAMMPS *); + ~PairSW3BTable() override; + void compute(int, int) override; + + static constexpr int NPARAMS_PER_LINE = 18; + + // use struct Table from class AngleTable + struct Table { + int ninput, fpflag; + double fplo, fphi, theta0; + double *afile, *efile, *ffile; + double *e2file, *f2file; + double delta, invdelta, deltasq6; + double *ang, *e, *de, *f, *df, *e2, *f2; + }; + + struct Param_Extension { + int tablenamelength; // length of table name + char *tablename; // name of associated angular table + int keywordlength; // length of key in table + char *keyword; // key in table + int tabstyle,tablength; // length of interpolation table (not ninput) and style + Table *angtable; // angle table + }; + + protected: + Param_Extension *extended_params; // parameter set for an I-J-K interaction + + void read_file(char *) override; + void threebody(Param *, Param *, Param *, Param_Extension*, double, double, double *, double *, double *, + double *, int, double &); + + void read_table(Table *, char *, char *); + void spline_table(Table *); + void compute_table(Table *,int length); + void bcast_table(Table *); + void null_table(Table *); + void free_table(Table *); + void free_param(Param_Extension *); + void param_extract(Table *, char *); + void spline(double *, double *, int, double, double, double *); + double splint(double *, double *, double *, int, double); + void uf_lookup(Param_Extension *, double, double &, double &); +}; + +} // namespace LAMMPS_NS + +#endif +#endif + +/* ERROR/WARNING messages: + +E: Illegal ... command + +Self-explanatory. Check the input script syntax and compare to the +documentation for the command. You can use -echo screen as a +command-line option when running LAMMPS to see the offending line. + +E: Incorrect args for pair coefficients + +Self-explanatory. Check the input script or data file. + +E: Pair style Stillinger-Weber requires atom IDs + +This is a requirement to use the SW potential. + +E: Pair style Stillinger-Weber requires newton pair on + +See the newton command. This is a restriction to use the SW +potential. + +E: All pair coeffs are not set + +All pair coefficients must be set in the data file or by the +pair_coeff command before running a simulation. + +E: Cannot open Stillinger-Weber potential file %s + +The specified SW potential file cannot be opened. Check that the path +and name are correct. + +E: Incorrect format in Stillinger-Weber potential file + +Incorrect number of words per line in the potential file. + +E: Illegal Stillinger-Weber parameter + +One or more of the coefficients defined in the potential file is +invalid. + +E: Potential file has duplicate entry + +The potential file has more than one entry for the same element. + +E: Potential file is missing an entry + +The potential file does not have a needed entry. + +*/ From 0e114b10415ffd682937c91bb91c412ac7c3e9f6 Mon Sep 17 00:00:00 2001 From: Christoph Scherer Date: Thu, 26 May 2022 13:35:40 +0200 Subject: [PATCH 214/585] doc/src/pair_sw_3b_table.rst: documentation for added pair style sw/3b/table --- doc/src/pair_sw_3b_table.rst | 309 +++++++++++++++++++++++++++++++++++ 1 file changed, 309 insertions(+) create mode 100644 doc/src/pair_sw_3b_table.rst diff --git a/doc/src/pair_sw_3b_table.rst b/doc/src/pair_sw_3b_table.rst new file mode 100644 index 0000000000..6ee13eb095 --- /dev/null +++ b/doc/src/pair_sw_3b_table.rst @@ -0,0 +1,309 @@ +.. index:: pair_style sw_table + +pair_style sw/3b/table command +=========================== + +Syntax +"""""" + +.. code-block:: LAMMPS + + pair_style style + +* style = *sw/3b/table* + + +Examples +"""""""" + +.. code-block:: LAMMPS + + pair_style sw/3b/table + pair_coeff * * spce.sw type + pair_coeff * * GaN.sw Ga N Ga + + +Description +""""""""""" + +The *sw/3b/table* style is a modification of the original :doc:`pair_style sw `. It has been +developed for coarse-grained simulations (of water) (:ref:`Scherer1 `), +but can be employed for all kinds of systems. It computes a modified 3-body :ref:`Stillinger-Weber ` +potential for the energy E of a system of atoms as + +.. math:: + + E & = \sum_i \sum_{j > i} \phi_2 (r_{ij}) + + \sum_i \sum_{j \neq i} \sum_{k > j} + \phi_3 (r_{ij}, r_{ik}, \theta_{ijk}) \\ + \phi_2(r_{ij}) & = A_{ij} \epsilon_{ij} \left[ B_{ij} (\frac{\sigma_{ij}}{r_{ij}})^{p_{ij}} - + (\frac{\sigma_{ij}}{r_{ij}})^{q_{ij}} \right] + \exp \left( \frac{\sigma_{ij}}{r_{ij} - a_{ij} \sigma_{ij}} \right) \\ + \phi_3(r_{ij},r_{ik},\theta_{ijk}) & = f^{\textrm{3b}}\left(\theta_{ijk}\right) + \exp \left( \frac{\gamma_{ij} \sigma_{ij}}{r_{ij} - a_{ij} \sigma_{ij}} \right) + \exp \left( \frac{\gamma_{ik} \sigma_{ik}}{r_{ik} - a_{ik} \sigma_{ik}} \right) + +where :math:`\phi_2` is a two-body term and :math:`\phi_3` is a +three-body term. The summations in the formula are over all neighbors J +and K of atom I within a cutoff distance :math:`a \sigma`. +In contrast to the original *sw* style, *sw/3b/table* allows for a flexible +three-body term :math:`f^{\textrm{3b}}\left(\theta_{ijk}\right)` which is read in +as a tabulated interaction. It can be parametrized with the csg_fmatch app of VOTCA +as available at: . + +Only a single pair_coeff command is used with the *sw/3b/table* style +which specifies a modified Stillinger-Weber potential file with parameters for all +needed elements. These are mapped to LAMMPS atom types by specifying +N_el additional arguments after the ".sw" filename in the pair_coeff command, +where N_el is the number of LAMMPS atom types: + +* ".sw" filename +* N_el element names = mapping of SW elements to atom types + +See the :doc:`pair_coeff ` page for alternate ways +to specify the path for the potential file. + +As an example, imagine a file SiC.sw has Stillinger-Weber values for +Si and C. If your LAMMPS simulation has 4 atoms types and you want +the first 3 to be Si, and the fourth to be C, you would use the following +pair_coeff command: + +.. code-block:: LAMMPS + + pair_coeff * * SiC.sw Si Si Si C + +The first 2 arguments must be \* \* so as to span all LAMMPS atom types. +The first three Si arguments map LAMMPS atom types 1,2,3 to the Si +element in the SW file. The final C argument maps LAMMPS atom type 4 +to the C element in the SW file. If a mapping value is specified as +NULL, the mapping is not performed. This can be used when a *sw/3b/table* +potential is used as part of the *hybrid* pair style. The NULL values +are placeholders for atom types that will be used with other +potentials. + +The (modified) Stillinger-Weber files have a ".sw" suffix. Lines that are not blank or +comments (starting with #) define parameters for a triplet of +elements. The parameters in a single entry correspond to the two-body +and three-body coefficients in the formula above. Here, also the suffix +".sw" is used though the original Stillinger-Weber file format is supplemented +with four additional lines per parameter block to specify the tabulated +three-body interaction. A single entry then contains: + +* element 1 (the center atom in a 3-body interaction) +* element 2 +* element 3 +* :math:`\epsilon` (energy units) +* :math:`\sigma` (distance units) +* a +* :math:`\lambda` +* :math:`\gamma` +* :math:`\cos\theta_0` +* A +* B +* p +* q +* tol +* filename +* keyword +* style +* N + +The A, B, p, and q parameters are used only for two-body interactions. +The :math:`\lambda` and :math:`\cos\theta_0` parameters, only used +for three-body interactions in the original Stillinger-Weber style, are read +in but ignored in this modified pair style. The :math:`\epsilon` parameter is only used +for two-body interactions in this modified pair style and not for the three-body +terms. The :math:`\sigma` and *a* parameters are used for both two-body and three-body +interactions. :math:`\gamma` is used only in the three-body +interactions, but is defined for pairs of atoms. The non-annotated +parameters are unitless. + +LAMMPS introduces an additional performance-optimization parameter tol +that is used for both two-body and three-body interactions. In the +Stillinger-Weber potential, the interaction energies become negligibly +small at atomic separations substantially less than the theoretical +cutoff distances. LAMMPS therefore defines a virtual cutoff distance +based on a user defined tolerance tol. The use of the virtual cutoff +distance in constructing atom neighbor lists can significantly reduce +the neighbor list sizes and therefore the computational cost. LAMMPS +provides a *tol* value for each of the three-body entries so that they +can be separately controlled. If tol = 0.0, then the standard +Stillinger-Weber cutoff is used. + +The additional parameters *filename*, *keyword*, *style*, and *N* refer to +the tabulated angular potential :math:`f^{\textrm{3b}}\left(\theta_{ijk}\right)`. +The tabulated angular potential has to be of the format as used in the +:doc:`angle_style table ` command: + +An interpolation tables of length *N* is created. The +interpolation is done in one of 2 *styles*: *linear* or *spline*. +For the *linear* style, the angle is used to find 2 surrounding table +values from which an energy or its derivative is computed by linear +interpolation. For the *spline* style, a cubic spline coefficients are computed and +stored at each of the *N* values in the table. The angle is used to +find the appropriate set of coefficients which are used to evaluate a +cubic polynomial which computes the energy or derivative. + +The *filename* specifies the file containing the tabulated energy and +derivative values of :math:`f^{\textrm{3b}}\left(\theta_{ijk}\right)`. +The *keyword* then specifies a section of the file. The +format of this file is as follows (without the +parenthesized comments): + +.. parsed-literal:: + + # Angle potential for harmonic (one or more comment or blank lines) + + HAM (keyword is the first text on line) + N 181 FP 0 0 EQ 90.0 (N, FP, EQ parameters) + (blank line) + 1 0.0 200.5 2.5 (index, angle, energy, derivative) + 2 1.0 198.0 2.5 + ... + 181 180.0 0.0 0.0 + +A section begins with a non-blank line whose first character is not a +"#"; blank lines or lines starting with "#" can be used as comments +between sections. The first line begins with a keyword which +identifies the section. The next line lists (in any +order) one or more parameters for the table. Each parameter is a +keyword followed by one or more numeric values. + +The parameter "N" is required and its value is the number of table +entries that follow. Note that this may be different than the *N* +specified in the Stillinger-Weber potential file. Let +Nsw = *N* in the ".sw" file, and Nfile = "N" in the +tabulated angular file. What LAMMPS does is a preliminary interpolation by +creating splines using the Nfile tabulated values as nodal points. It +uses these to interpolate as needed to generate energy and derivative +values at Ntable different points. The resulting tables of length +Nsw are then used as described above, when computing energy and +force for individual angles and their atoms. This means that if you +want the interpolation tables of length Nsw to match exactly what +is in the tabulated file (with effectively no preliminary +interpolation), you should set Nsw = Nfile. + +The "FP" parameter is optional. If used, it is followed by two values +fplo and fphi, which are the second derivatives at the innermost and +outermost angle settings. These values are needed by the spline +construction routines. If not specified by the "FP" parameter, they +are estimated (less accurately) by the first two and last two +derivative values in the table. + +The "EQ" parameter is also optional. If used, it is followed by a the +equilibrium angle value, which is used, for example, by the :doc:`fix shake ` command. If not used, the equilibrium angle is +set to 180.0. + +Following a blank line, the next N lines of the angular table file list the tabulated values. +On each line, the first value is the index from 1 to N, the second value is +the angle value (in degrees), the third value is the energy (in energy +units), and the fourth is -dE/d(theta) (also in energy units). The third +term is the energy of the 3-atom configuration for the specified +angle. The last term is the derivative of the energy with respect to +the angle (in degrees, not radians). Thus the units of the last term +are still energy, not force. The angle values must increase from one +line to the next. The angle values must also begin with 0.0 and end +with 180.0, i.e. span the full range of possible angles. + +Note that one angular potential file can contain many sections, each with a tabulated +potential. LAMMPS reads the file section by section until it finds +one that matches the specified *keyword* of appropriate section of the ".sw" file. + +The Stillinger-Weber potential file must contain entries for all the +elements listed in the pair_coeff command. It can also contain +entries for additional elements not being used in a particular +simulation; LAMMPS ignores those entries. + +For a single-element simulation, only a single entry is required +(e.g. SiSiSi). For a two-element simulation, the file must contain 8 +entries (for SiSiSi, SiSiC, SiCSi, SiCC, CSiSi, CSiC, CCSi, CCC), that +specify SW parameters for all permutations of the two elements +interacting in three-body configurations. Thus for 3 elements, 27 +entries would be required, etc. + +As annotated above, the first element in the entry is the center atom +in a three-body interaction. Thus an entry for SiCC means a Si atom +with 2 C atoms as neighbors. The parameter values used for the +two-body interaction come from the entry where the second and third +elements are the same. Thus the two-body parameters for Si +interacting with C, comes from the SiCC entry. The three-body +angular potential :math:`f^{\textrm{3b}}\left(\theta_{ijk}\right)` +can in principle be specific to the three elements of the +configuration. However, the user must ensure that it makes physically sense. +Note also that the function :math:`\phi_3` contains two exponential +screening factors with parameter values from the ij pair and ik +pairs. So :math:`\phi_3` for a C atom bonded to a Si atom and a second C atom +will depend on the three-body parameters for the CSiC entry, and also +on the two-body parameters for the CCC and CSiSi entries. Since the +order of the two neighbors is arbitrary, the three-body parameters +and the tabulated angular potential for +entries CSiC and CCSi should be the same. Similarly, the two-body +parameters for entries SiCC and CSiSi should also be the same. The +parameters used only for two-body interactions (A, B, p, and q) in +entries whose second and third element are different (e.g. SiCSi) are not +used for anything and can be set to 0.0 if desired. +This is also true for the parameters in :math:`\phi_3` that are +taken from the ij and ik pairs (:math:`\sigma`, *a*, :math:`\gamma`) + +---------- + +.. include:: accel_styles.rst + +.. note:: + + When using the INTEL package with this style, there is an additional + 5 to 10 percent performance improvement when the Stillinger-Weber + parameters p and q are set to 4 and 0 respectively. These + parameters are common for modeling silicon and water. + +---------- + +Mixing, shift, table, tail correction, restart, rRESPA info +""""""""""""""""""""""""""""""""""""""""""""""""""""""""""" + +For atom type pairs I,J and I != J, where types I and J correspond to +two different element types, mixing is performed by LAMMPS as +described above from values in the potential file, but not for the +tabulated angular potential file. + +This pair style does not support the :doc:`pair_modify ` +shift, table, and tail options. + +This pair style does not write its information to :doc:`binary restart files `, since it is stored in potential files. +Thus, you need to re-specify the pair_style and pair_coeff commands in an input +script that reads a restart file. + +This pair style can only be used via the *pair* keyword of the +:doc:`run_style respa ` command. It does not support the +*inner*, *middle*, *outer* keywords. + +---------- + +Restrictions +"""""""""""" + +This is a user pair style. For more information, see :ref:`Scherer1 `. It is only enabled +if LAMMPS was explicitly built with it. + +This pair style requires the :doc:`newton ` setting to be "on" +for pair interactions. + +For an example of an extended Stillinger-Weber potential file, have a look at the tutorial +in the tutorial folder. + +Related commands +"""""""""""""""" + +:doc:`pair_coeff ` + + +---------- + +.. _Stillinger2: + +**(Stillinger)** Stillinger and Weber, Phys Rev B, 31, 5262 (1985). + +.. _Scherer1: + +**(Scherer1)** C. Scherer and D. Andrienko, Phys. Chem. Chem. Phys. 20, 22387-22394 (2018). + From 770454cb8b0f39d718e04ead699a7d8f5328fb29 Mon Sep 17 00:00:00 2001 From: Christoph Scherer Date: Thu, 26 May 2022 14:00:06 +0200 Subject: [PATCH 215/585] examples/PACKAGES/pair_sw_3b_table: added example for new pair style sw/3b/table --- examples/PACKAGES/pair_sw_3b_table/README | 41 + examples/PACKAGES/pair_sw_3b_table/run.sh | 5 + examples/PACKAGES/pair_sw_3b_table/spce.data | 1015 ++++++++++++++ examples/PACKAGES/pair_sw_3b_table/spce.in | 45 + examples/PACKAGES/pair_sw_3b_table/spce.sw | 18 + .../PACKAGES/pair_sw_3b_table/table_CG_CG.txt | 1203 +++++++++++++++++ .../pair_sw_3b_table/table_CG_CG_CG.txt | 1004 ++++++++++++++ 7 files changed, 3331 insertions(+) create mode 100644 examples/PACKAGES/pair_sw_3b_table/README create mode 100755 examples/PACKAGES/pair_sw_3b_table/run.sh create mode 100644 examples/PACKAGES/pair_sw_3b_table/spce.data create mode 100644 examples/PACKAGES/pair_sw_3b_table/spce.in create mode 100644 examples/PACKAGES/pair_sw_3b_table/spce.sw create mode 100644 examples/PACKAGES/pair_sw_3b_table/table_CG_CG.txt create mode 100644 examples/PACKAGES/pair_sw_3b_table/table_CG_CG_CG.txt diff --git a/examples/PACKAGES/pair_sw_3b_table/README b/examples/PACKAGES/pair_sw_3b_table/README new file mode 100644 index 0000000000..9d158bf392 --- /dev/null +++ b/examples/PACKAGES/pair_sw_3b_table/README @@ -0,0 +1,41 @@ +Example for pair style sw/table +================================ + +This example contains all required input files for the simulation of CG SPC/E water with +the user pair style sw/table, as well as a run.sh script. + +To run the example, you have to compile LAMMPS with the MANYBODY package, including pair_sw_3b_table.h and pair_sw_3b_table.h. + +Running the simulation, you will reproduce results of the following publication: + +C. Scherer, and D. Andrienko, Understanding three-body contributions to coarse-grained force fields, Phys. Chem. Chem. Phys, 20(34):22387–22394, 2018, http://xlink.rsc.org/?DOI=C8CP00746B + +Here, a water molecule is represented by one coarse-grained (CG) bead. The +two-body (table_CG_CG.txt) and three-body angular (table_CG_CG_CG.txt) interaction potentials +have been parametrized with force-matching (FM) with the VOTCA package (https://gitlab.mpcdf.mpg.de/votca/votca). +For more details, have a look at the publication. For a example on the parametrization, have a look at +https://gitlab.mpcdf.mpg.de/votca/votca/-/tree/master/csg-examples/guide and +https://gitlab.mpcdf.mpg.de/votca/votca/-/tree/master/csg-examples/spce/3body_sw. + +The folder contains the LAMMPS data file (spce.data) with the starting configuration +of 1000 CG water molecules, an input file (spce.in) and a (modified) Stillinger-Weber file (spce.sw). + +The lammps input file contains the lines specifying the pair style and coefficients: + +- pair_style hybrid/overlay table linear 1200 sw/3b/table - use a combination of pair_style table with 1200 linear table entries and the pair_style sw/3b/table +- pair_coeff 1 1 table table_CG_CG.txt VOTCA - set the table name and keyword for the pair_style table +- pair_coeff * * sw/3b/table spce.sw type - set the name of the Stillinger-Weber file for the pair_style sw/3b/table + +A hybrid pair style is used, where pair forces are calculated as a tabulated interaction (table_CG_CG.txt) and the +pair style sw/table is only used to calculate the three-body forces. Therefore, in the Stillinger-Weber file all +parameters refering to two-body interactions are set to zero. As explained in the documentation of this pair +style, the .sw file contains the +additional lines refering to the tabulated angular potential: + +- table_CG_CG_CG.txt - file name of tabulated angular potential +- VOTCA - keyword for tabulated angular potential +- linear - angular table is of linear style +- 1001 - 1001 table entries + +The LAMMPS simulation is a standard nvt simulation. A dump file is output with the positions and forces every 10 time steps. +You can calculate the pair distribution and compare it to the one(s) in the publicattion. diff --git a/examples/PACKAGES/pair_sw_3b_table/run.sh b/examples/PACKAGES/pair_sw_3b_table/run.sh new file mode 100755 index 0000000000..8f64855b13 --- /dev/null +++ b/examples/PACKAGES/pair_sw_3b_table/run.sh @@ -0,0 +1,5 @@ +#! /bin/bash -e + +#run the LAMMPS simulation (needs a current LAMMPS version compiled with the user pair_style sw/table) +lmp < spce.in > spce.out + diff --git a/examples/PACKAGES/pair_sw_3b_table/spce.data b/examples/PACKAGES/pair_sw_3b_table/spce.data new file mode 100644 index 0000000000..a56ab1b10c --- /dev/null +++ b/examples/PACKAGES/pair_sw_3b_table/spce.data @@ -0,0 +1,1015 @@ +Data File for CG Water + +1000 atoms +1 atom types + +0 31.0648 xlo xhi +0 31.0648 ylo yhi +0 31.0648 zlo zhi + +Masses + +1 18.0154 + +Atoms + +1 1 18.26 24.7 15.77 +2 1 12.63 1.42 27.01 +3 1 10.39 29.11 13.56 +4 1 26.47 16.64 7.23 +5 1 10.66 23.41 27.33 +6 1 19.08 3.2 21.63 +7 1 11.17 26.19 1.44 +8 1 4.61 4.04 25.72 +9 1 4.61 22.91 8.33 +10 1 30.61 22.71 25.18 +11 1 6.38 18.92 16.87 +12 1 17.83 12.53 11.09 +13 1 14.89 2.43 22.44 +14 1 28.36 30.9 26.38 +15 1 25.73 28.56 8.32 +16 1 19.61 20.22 4.43 +17 1 25.96 30.32 24.22 +18 1 14.51 17.35 16.41 +19 1 30.23 17.26 10.71 +20 1 22.68 23.23 2.3 +21 1 10.89 15.76 14.33 +22 1 1.46 20.46 12.48 +23 1 12.73 19.57 2.71 +24 1 1.21 12.02 9.88 +25 1 2.63 14.4 23.71 +26 1 16.91 20.37 4.73 +27 1 28.02 7.7 30.08 +28 1 21.22 22.47 19.66 +29 1 14.0 28.15 0.14 +30 1 19.62 19.73 1.11 +31 1 28.29 24.36 10.15 +32 1 14.05 1.1 17.64 +33 1 12.2 23.75 24.83 +34 1 24.56 26.02 13.57 +35 1 12.13 8.39 7.17 +36 1 20.47 22.28 25.02 +37 1 11.06 7.63 24.11 +38 1 6.52 22.64 30.46 +39 1 16.51 24.78 18.58 +40 1 30.18 20.56 29.19 +41 1 25.26 7.8 25.98 +42 1 20.37 4.16 3.88 +43 1 18.85 27.34 27.83 +44 1 17.72 29.84 12.78 +45 1 19.26 14.48 19.38 +46 1 29.73 4.46 4.96 +47 1 9.52 26.27 30.33 +48 1 6.55 9.25 20.32 +49 1 10.49 1.91 23.31 +50 1 17.63 1.17 14.48 +51 1 1.56 25.17 4.69 +52 1 9.08 10.39 2.29 +53 1 25.92 7.4 21.53 +54 1 25.3 5.14 28.4 +55 1 5.63 23.26 19.85 +56 1 9.6 9.85 24.85 +57 1 3.32 2.77 9.12 +58 1 28.54 15.28 22.18 +59 1 20.45 8.24 18.25 +60 1 12.86 3.73 11.61 +61 1 7.42 12.05 13.54 +62 1 1.73 28.54 25.27 +63 1 3.25 22.18 23.7 +64 1 3.27 25.38 2.24 +65 1 13.46 15.67 19.28 +66 1 31.0 6.91 13.61 +67 1 4.85 27.3 12.67 +68 1 24.48 13.52 4.98 +69 1 23.93 29.62 19.71 +70 1 5.03 13.35 19.5 +71 1 24.58 13.46 19.59 +72 1 7.42 6.82 9.03 +73 1 28.76 15.1 3.33 +74 1 12.38 17.21 6.63 +75 1 15.75 21.23 27.02 +76 1 4.58 5.06 28.19 +77 1 26.04 23.3 25.38 +78 1 30.02 7.27 9.52 +79 1 6.93 10.03 24.54 +80 1 5.61 26.93 27.34 +81 1 29.12 19.12 5.54 +82 1 18.44 27.8 14.75 +83 1 14.1 23.13 9.78 +84 1 24.12 5.55 20.72 +85 1 2.52 10.99 18.44 +86 1 1.76 6.41 21.47 +87 1 25.22 9.56 30.66 +88 1 11.87 13.25 9.12 +89 1 19.46 0.3 22.07 +90 1 28.82 12.29 11.36 +91 1 28.47 30.29 14.09 +92 1 25.51 20.94 24.33 +93 1 1.14 25.4 8.76 +94 1 1.33 27.98 3.09 +95 1 20.57 26.97 -0.04 +96 1 22.73 1.18 0.62 +97 1 19.16 16.99 30.52 +98 1 0.39 9.65 9.02 +99 1 4.41 7.21 3.22 +100 1 11.07 30.64 25.91 +101 1 7.93 25.84 26.26 +102 1 26.76 2.51 2.93 +103 1 30.8 18.15 18.49 +104 1 10.2 7.46 30.44 +105 1 4.77 20.39 26.99 +106 1 25.27 26.77 1.64 +107 1 28.51 13.99 9.33 +108 1 13.86 8.04 24.9 +109 1 30.67 29.88 23.01 +110 1 29.49 30.58 30.02 +111 1 28.74 5.08 30.95 +112 1 13.21 4.31 30.96 +113 1 5.27 3.66 5.02 +114 1 29.43 7.99 17.07 +115 1 4.19 1.37 16.63 +116 1 1.27 27.81 16.56 +117 1 30.64 5.73 25.91 +118 1 10.33 5.33 26.48 +119 1 11.56 21.77 14.77 +120 1 26.46 27.17 5.7 +121 1 14.85 25.79 8.64 +122 1 22.62 6.18 17.61 +123 1 3.45 18.53 11.84 +124 1 11.65 18.17 15.97 +125 1 23.16 17.0 1.5 +126 1 18.92 16.01 3.98 +127 1 30.05 0.25 5.23 +128 1 26.06 11.96 21.96 +129 1 16.82 2.0 10.25 +130 1 19.58 2.63 24.75 +131 1 20.09 14.75 26.62 +132 1 3.14 0.05 26.13 +133 1 4.86 11.79 12.99 +134 1 1.86 11.32 28.57 +135 1 8.82 28.6 6.22 +136 1 20.85 24.68 23.87 +137 1 7.58 25.15 3.44 +138 1 23.46 9.13 8.11 +139 1 6.45 10.24 27.37 +140 1 15.06 10.35 26.71 +141 1 13.8 18.39 26.5 +142 1 5.11 7.7 5.83 +143 1 23.27 23.16 6.67 +144 1 6.33 1.31 11.37 +145 1 14.66 22.28 21.43 +146 1 7.9 8.65 0.61 +147 1 21.83 3.67 26.17 +148 1 1.41 23.66 11.09 +149 1 10.19 17.23 22.71 +150 1 29.53 27.31 23.19 +151 1 28.69 11.38 2.33 +152 1 1.07 2.97 14.53 +153 1 23.47 30.53 14.32 +154 1 1.59 18.83 14.75 +155 1 20.38 30.6 24.38 +156 1 19.81 29.95 27.9 +157 1 12.68 27.59 26.46 +158 1 20.46 9.14 29.06 +159 1 8.69 13.98 24.71 +160 1 0.72 9.29 30.28 +161 1 11.81 20.55 12.28 +162 1 23.8 13.8 9.4 +163 1 13.63 0.51 0.95 +164 1 2.33 6.68 14.95 +165 1 15.98 6.35 25.28 +166 1 7.38 14.88 18.44 +167 1 17.07 20.48 29.16 +168 1 14.53 1.49 8.4 +169 1 28.45 1.21 20.58 +170 1 0.07 5.28 29.45 +171 1 26.0 9.98 15.37 +172 1 14.56 6.91 14.46 +173 1 20.6 9.09 23.04 +174 1 26.02 4.59 0.14 +175 1 5.21 21.9 17.55 +176 1 2.44 7.72 1.47 +177 1 1.25 30.0 13.48 +178 1 27.27 23.13 14.61 +179 1 24.04 15.61 21.64 +180 1 25.13 5.24 17.43 +181 1 4.2 15.98 12.34 +182 1 26.92 13.54 12.87 +183 1 3.38 19.38 9.08 +184 1 27.75 25.03 2.15 +185 1 26.13 20.68 16.54 +186 1 8.3 14.6 13.49 +187 1 3.04 22.87 29.93 +188 1 9.5 26.41 21.23 +189 1 6.53 2.16 2.75 +190 1 6.37 29.04 2.63 +191 1 26.58 4.38 19.69 +192 1 28.44 6.56 14.66 +193 1 25.55 11.1 28.03 +194 1 25.5 18.39 28.73 +195 1 27.67 23.47 5.65 +196 1 13.69 14.81 16.17 +197 1 22.97 27.61 24.11 +198 1 2.06 18.58 30.22 +199 1 2.07 7.13 29.2 +200 1 13.0 7.26 17.76 +201 1 10.04 16.22 30.62 +202 1 6.54 9.8 17.47 +203 1 5.65 12.68 0.64 +204 1 20.84 20.25 23.02 +205 1 22.48 27.63 21.48 +206 1 15.61 22.73 5.36 +207 1 3.52 30.36 6.24 +208 1 6.38 17.25 26.36 +209 1 14.13 10.57 22.63 +210 1 10.22 25.11 3.64 +211 1 16.63 14.7 25.08 +212 1 3.51 29.69 2.76 +213 1 19.2 11.9 21.44 +214 1 30.8 23.85 14.75 +215 1 21.02 14.34 12.4 +216 1 2.75 22.13 27.29 +217 1 29.27 14.29 6.8 +218 1 8.44 20.67 5.23 +219 1 9.42 20.06 22.95 +220 1 30.83 10.64 19.73 +221 1 19.33 14.14 8.94 +222 1 14.18 11.32 18.19 +223 1 26.55 2.39 28.55 +224 1 6.83 16.57 8.9 +225 1 13.98 8.79 1.97 +226 1 4.94 3.0 23.16 +227 1 25.39 29.46 0.63 +228 1 15.32 16.43 2.45 +229 1 5.26 29.73 29.87 +230 1 26.92 14.84 19.93 +231 1 11.87 30.08 4.52 +232 1 7.17 6.71 2.23 +233 1 10.46 1.13 18.11 +234 1 28.59 20.57 25.68 +235 1 26.54 4.84 8.44 +236 1 16.46 18.37 26.15 +237 1 30.53 0.74 15.31 +238 1 27.25 6.31 27.09 +239 1 22.42 1.65 3.87 +240 1 17.85 3.77 8.02 +241 1 11.82 8.23 11.15 +242 1 8.62 27.66 15.87 +243 1 25.19 1.89 18.37 +244 1 14.0 21.96 30.21 +245 1 29.3 1.73 28.29 +246 1 9.35 24.02 12.03 +247 1 1.05 21.5 0.35 +248 1 21.87 20.54 2.54 +249 1 10.59 15.98 17.51 +250 1 22.76 6.0 9.32 +251 1 0.31 9.13 11.87 +252 1 29.16 25.13 18.29 +253 1 1.23 29.08 7.75 +254 1 30.01 28.49 26.21 +255 1 1.87 5.92 5.03 +256 1 1.15 10.27 22.35 +257 1 11.83 10.31 5.16 +258 1 20.89 8.28 8.14 +259 1 13.48 11.78 28.37 +260 1 6.82 10.48 10.25 +261 1 7.34 4.49 18.73 +262 1 5.49 22.37 14.23 +263 1 12.31 21.05 27.47 +264 1 24.09 17.4 8.65 +265 1 22.03 11.54 20.98 +266 1 16.68 13.17 0.68 +267 1 5.52 1.47 8.78 +268 1 14.95 11.83 7.95 +269 1 5.9 10.66 7.12 +270 1 10.06 11.28 30.73 +271 1 17.72 10.71 27.46 +272 1 13.6 6.23 10.82 +273 1 23.42 30.72 9.31 +274 1 23.27 4.25 3.8 +275 1 13.79 8.37 21.07 +276 1 5.01 30.13 12.61 +277 1 26.04 24.45 17.25 +278 1 22.59 14.31 0.81 +279 1 23.74 10.37 17.17 +280 1 23.4 8.52 12.55 +281 1 10.53 23.97 21.96 +282 1 0.69 13.92 28.42 +283 1 6.94 6.27 15.01 +284 1 29.8 20.92 3.41 +285 1 10.19 20.68 19.0 +286 1 26.38 25.4 28.89 +287 1 12.34 26.9 8.27 +288 1 15.0 7.69 6.4 +289 1 24.75 13.1 2.24 +290 1 4.5 20.58 6.78 +291 1 23.27 18.25 11.48 +292 1 25.92 26.39 22.66 +293 1 24.63 4.21 6.52 +294 1 16.68 15.05 15.6 +295 1 26.39 16.17 29.89 +296 1 10.12 6.21 8.63 +297 1 14.41 14.67 12.23 +298 1 19.59 3.47 1.47 +299 1 28.21 22.43 18.25 +300 1 27.87 29.74 11.47 +301 1 22.53 24.1 13.94 +302 1 12.55 1.58 29.82 +303 1 17.45 21.28 8.34 +304 1 16.3 10.75 16.22 +305 1 16.34 13.25 17.65 +306 1 8.44 4.52 0.93 +307 1 17.47 23.79 2.3 +308 1 29.04 26.8 5.13 +309 1 13.13 11.34 24.9 +310 1 24.33 13.0 13.32 +311 1 8.21 29.74 24.23 +312 1 21.79 28.0 5.85 +313 1 13.74 20.08 10.26 +314 1 20.92 24.38 6.01 +315 1 9.83 29.56 17.99 +316 1 26.66 30.76 2.95 +317 1 24.34 3.08 1.67 +318 1 28.09 10.69 23.33 +319 1 7.08 25.28 0.77 +320 1 15.34 1.12 29.82 +321 1 26.07 12.55 7.74 +322 1 16.85 0.81 21.24 +323 1 9.96 0.57 6.36 +324 1 29.4 2.54 1.18 +325 1 5.81 1.0 5.42 +326 1 25.16 24.89 11.15 +327 1 15.43 24.93 13.71 +328 1 24.6 10.06 10.58 +329 1 20.4 12.04 15.51 +330 1 15.72 18.9 0.21 +331 1 16.5 17.21 28.81 +332 1 16.79 3.11 12.74 +333 1 22.75 6.22 6.6 +334 1 8.09 19.86 30.92 +335 1 24.15 8.75 23.65 +336 1 12.24 30.51 15.39 +337 1 8.15 26.8 18.69 +338 1 0.1 15.0 15.49 +339 1 29.84 15.71 30.0 +340 1 15.39 18.25 11.17 +341 1 1.2 15.49 18.8 +342 1 27.55 9.81 17.9 +343 1 18.93 8.9 10.06 +344 1 28.35 12.36 4.82 +345 1 11.21 13.71 30.62 +346 1 2.5 16.67 16.33 +347 1 0.47 4.2 6.99 +348 1 23.72 4.38 12.28 +349 1 16.59 3.54 16.9 +350 1 17.31 17.81 15.8 +351 1 11.58 0.3 21.21 +352 1 23.67 21.91 15.84 +353 1 7.74 2.78 23.52 +354 1 14.34 9.65 4.52 +355 1 23.35 10.88 14.55 +356 1 3.51 10.03 20.99 +357 1 14.63 21.34 1.75 +358 1 24.37 8.39 2.96 +359 1 14.8 15.5 30.48 +360 1 2.59 1.32 12.76 +361 1 0.16 13.81 25.49 +362 1 11.26 10.11 27.84 +363 1 27.8 18.65 15.07 +364 1 5.07 5.43 21.33 +365 1 14.06 5.26 19.67 +366 1 3.76 18.23 19.36 +367 1 26.68 27.25 10.67 +368 1 7.72 19.58 13.64 +369 1 29.48 16.94 16.45 +370 1 28.18 13.38 30.28 +371 1 29.97 10.41 16.17 +372 1 11.97 28.73 29.31 +373 1 14.88 0.79 25.43 +374 1 8.98 23.85 7.66 +375 1 4.78 8.21 9.79 +376 1 21.74 20.61 28.64 +377 1 20.36 18.75 17.92 +378 1 12.61 21.65 23.18 +379 1 6.36 29.76 8.49 +380 1 12.51 26.69 18.69 +381 1 22.2 17.41 6.86 +382 1 11.7 6.53 21.66 +383 1 4.62 16.22 3.24 +384 1 0.76 13.73 0.83 +385 1 21.91 13.43 5.67 +386 1 17.36 6.16 4.12 +387 1 0.34 28.1 11.89 +388 1 2.43 26.92 20.47 +389 1 0.99 22.41 4.14 +390 1 23.77 24.66 24.16 +391 1 22.41 7.79 20.57 +392 1 16.4 22.82 23.46 +393 1 24.68 28.28 17.44 +394 1 14.99 26.21 27.12 +395 1 0.75 13.41 7.7 +396 1 16.43 5.69 21.09 +397 1 19.5 6.71 27.89 +398 1 14.32 17.4 22.9 +399 1 29.04 27.81 19.17 +400 1 9.52 19.68 10.69 +401 1 5.33 27.17 17.3 +402 1 5.2 12.64 9.11 +403 1 9.8 6.14 19.74 +404 1 9.86 22.71 1.2 +405 1 0.84 12.31 14.9 +406 1 18.79 12.07 17.76 +407 1 27.21 25.79 14.27 +408 1 6.11 1.01 19.83 +409 1 8.44 5.68 12.85 +410 1 22.42 26.4 1.81 +411 1 24.0 20.11 18.63 +412 1 2.32 26.11 12.18 +413 1 26.06 7.28 15.77 +414 1 9.96 9.13 19.49 +415 1 10.74 12.01 25.79 +416 1 30.39 1.07 11.77 +417 1 9.49 20.19 26.63 +418 1 15.99 30.59 6.78 +419 1 11.0 30.74 0.96 +420 1 23.67 30.14 22.75 +421 1 24.14 9.9 19.82 +422 1 5.88 5.5 7.25 +423 1 3.45 10.72 9.52 +424 1 11.78 25.26 29.31 +425 1 15.95 27.28 17.71 +426 1 17.99 16.5 8.95 +427 1 28.47 0.47 23.29 +428 1 14.06 1.39 12.17 +429 1 19.28 23.85 8.27 +430 1 13.62 4.42 14.21 +431 1 2.98 9.89 12.04 +432 1 7.35 14.53 10.79 +433 1 15.55 0.87 3.17 +434 1 7.7 24.24 23.88 +435 1 17.61 8.64 6.93 +436 1 5.17 26.9 3.74 +437 1 1.06 17.17 27.8 +438 1 18.8 9.64 19.81 +439 1 8.36 1.64 0.63 +440 1 13.68 14.97 7.75 +441 1 29.56 0.55 17.98 +442 1 3.01 24.45 14.3 +443 1 11.98 7.48 26.92 +444 1 19.13 24.44 27.57 +445 1 11.75 14.57 11.88 +446 1 13.1 4.54 22.64 +447 1 7.2 21.26 28.21 +448 1 24.85 22.96 28.77 +449 1 15.0 23.95 16.32 +450 1 24.6 14.43 15.56 +451 1 3.05 13.66 17.69 +452 1 3.0 3.39 6.37 +453 1 24.92 22.04 13.42 +454 1 21.24 2.56 17.68 +455 1 19.69 0.3 11.75 +456 1 5.73 29.89 26.41 +457 1 7.62 30.1 0.37 +458 1 14.62 28.23 20.86 +459 1 8.72 5.14 23.94 +460 1 9.94 25.78 9.45 +461 1 17.3 4.53 0.74 +462 1 17.58 12.58 14.58 +463 1 8.64 2.55 20.15 +464 1 21.07 10.96 26.32 +465 1 27.85 4.23 10.9 +466 1 20.41 29.07 20.84 +467 1 9.35 12.65 10.7 +468 1 9.88 0.73 3.41 +469 1 26.64 20.78 1.33 +470 1 25.47 19.72 10.96 +471 1 1.01 5.01 12.19 +472 1 10.11 27.98 23.8 +473 1 17.51 0.24 28.51 +474 1 21.85 14.89 8.07 +475 1 18.22 12.88 29.4 +476 1 10.97 16.02 2.55 +477 1 4.3 25.33 5.86 +478 1 12.67 27.62 3.28 +479 1 12.18 24.26 16.74 +480 1 0.24 29.32 20.41 +481 1 5.03 15.5 6.14 +482 1 11.11 12.43 6.7 +483 1 10.14 4.47 15.0 +484 1 2.9 6.91 24.11 +485 1 30.6 4.29 16.4 +486 1 9.61 4.66 29.44 +487 1 5.38 17.6 1.1 +488 1 3.71 5.22 11.92 +489 1 8.93 11.33 8.19 +490 1 31.02 28.82 0.48 +491 1 0.81 2.74 23.14 +492 1 16.45 28.36 8.16 +493 1 2.1 8.36 17.2 +494 1 25.82 16.89 1.44 +495 1 20.21 11.2 11.56 +496 1 13.88 23.42 27.01 +497 1 30.15 5.56 2.54 +498 1 1.76 17.51 24.41 +499 1 18.18 8.62 16.29 +500 1 4.41 20.18 15.26 +501 1 7.05 29.39 19.64 +502 1 22.92 21.56 26.41 +503 1 29.43 3.25 12.91 +504 1 16.92 25.1 29.07 +505 1 25.4 12.48 17.22 +506 1 7.4 5.74 28.39 +507 1 0.14 3.32 27.06 +508 1 29.61 24.31 3.76 +509 1 13.25 25.77 23.43 +510 1 19.18 28.02 24.33 +511 1 3.66 10.37 26.9 +512 1 12.53 11.26 1.28 +513 1 28.21 7.27 11.49 +514 1 26.9 9.35 3.39 +515 1 18.87 28.09 9.36 +516 1 9.3 30.5 15.62 +517 1 12.34 13.23 3.13 +518 1 27.93 26.52 26.46 +519 1 7.78 9.29 14.0 +520 1 16.12 6.82 1.73 +521 1 0.63 2.82 20.33 +522 1 12.2 26.56 13.2 +523 1 6.16 16.1 15.43 +524 1 13.49 24.29 6.85 +525 1 28.61 10.73 30.64 +526 1 19.98 17.97 5.68 +527 1 2.75 19.83 4.73 +528 1 18.41 26.18 2.29 +529 1 22.35 24.43 11.05 +530 1 4.45 4.92 15.13 +531 1 16.8 18.43 21.99 +532 1 2.08 4.57 24.87 +533 1 26.03 2.02 24.82 +534 1 15.65 30.12 19.2 +535 1 27.88 13.79 27.66 +536 1 29.03 7.86 2.9 +537 1 2.68 5.55 9.4 +538 1 30.45 11.98 23.35 +539 1 2.08 19.71 21.15 +540 1 11.06 3.11 4.38 +541 1 21.61 14.28 20.83 +542 1 15.85 5.82 12.29 +543 1 29.7 22.61 8.47 +544 1 29.5 7.81 27.38 +545 1 24.12 20.22 0.4 +546 1 16.0 25.22 21.34 +547 1 19.8 25.24 13.43 +548 1 7.11 16.71 4.39 +549 1 4.59 0.13 21.8 +550 1 20.94 12.01 28.92 +551 1 12.99 2.09 6.04 +552 1 19.45 19.38 14.86 +553 1 12.98 23.9 12.88 +554 1 13.06 12.04 20.67 +555 1 17.56 1.18 25.76 +556 1 29.88 16.58 1.42 +557 1 6.04 13.87 25.34 +558 1 25.5 6.08 10.63 +559 1 20.34 11.15 2.51 +560 1 3.82 11.92 15.57 +561 1 10.47 18.64 8.01 +562 1 13.02 24.92 20.67 +563 1 20.03 29.78 7.22 +564 1 8.36 11.63 28.63 +565 1 14.06 21.56 15.74 +566 1 9.4 28.78 29.81 +567 1 9.07 10.18 22.15 +568 1 11.47 22.66 29.81 +569 1 17.02 8.02 27.19 +570 1 29.56 18.32 21.38 +571 1 8.58 8.58 11.23 +572 1 22.15 19.86 15.25 +573 1 12.34 29.83 7.16 +574 1 20.52 25.35 20.66 +575 1 21.23 5.6 23.05 +576 1 23.45 10.69 5.93 +577 1 14.15 4.81 4.29 +578 1 8.26 24.58 28.88 +579 1 10.03 3.4 7.88 +580 1 25.65 7.23 0.84 +581 1 7.28 26.7 9.09 +582 1 20.47 29.31 16.02 +583 1 4.44 7.7 27.1 +584 1 27.95 23.13 0.39 +585 1 19.82 18.98 12.12 +586 1 20.01 5.07 14.72 +587 1 1.66 1.23 5.19 +588 1 5.6 11.21 22.59 +589 1 3.81 22.68 4.63 +590 1 17.47 14.06 22.25 +591 1 16.77 22.61 10.71 +592 1 7.2 26.5 22.52 +593 1 10.75 17.97 28.76 +594 1 16.61 8.28 20.88 +595 1 0.81 27.72 28.37 +596 1 6.78 22.71 4.37 +597 1 27.35 28.79 17.13 +598 1 15.16 3.34 2.07 +599 1 19.69 29.89 30.66 +600 1 17.34 20.23 2.18 +601 1 15.65 15.76 9.8 +602 1 19.07 19.02 8.23 +603 1 26.13 0.42 7.37 +604 1 4.29 9.29 15.94 +605 1 7.86 7.42 4.84 +606 1 23.4 1.93 16.16 +607 1 5.27 27.16 0.17 +608 1 27.08 14.52 1.58 +609 1 8.34 11.25 18.53 +610 1 10.4 17.83 12.7 +611 1 8.86 18.1 18.73 +612 1 17.69 22.57 26.0 +613 1 6.1 6.61 11.68 +614 1 24.32 13.38 23.99 +615 1 0.13 20.78 22.53 +616 1 10.96 20.82 6.33 +617 1 28.46 1.62 7.03 +618 1 16.9 4.13 23.44 +619 1 1.89 11.75 5.82 +620 1 3.27 20.91 2.26 +621 1 11.14 15.5 24.78 +622 1 21.76 3.5 20.99 +623 1 3.95 12.22 24.49 +624 1 7.26 23.31 16.11 +625 1 19.28 20.97 21.06 +626 1 7.2 17.22 22.12 +627 1 16.26 10.81 24.17 +628 1 1.54 24.72 17.86 +629 1 17.74 0.11 1.5 +630 1 25.85 5.87 23.82 +631 1 4.21 7.73 13.47 +632 1 20.87 8.0 25.94 +633 1 22.23 3.22 8.98 +634 1 13.72 30.72 23.05 +635 1 4.91 26.26 19.85 +636 1 14.82 27.52 13.76 +637 1 27.5 3.72 26.36 +638 1 27.62 9.82 10.27 +639 1 19.32 8.78 3.53 +640 1 16.33 28.86 1.39 +641 1 30.26 10.13 4.93 +642 1 14.94 29.37 4.67 +643 1 7.61 12.27 21.0 +644 1 5.31 18.92 23.16 +645 1 25.19 3.1 14.51 +646 1 8.12 21.6 9.56 +647 1 20.35 17.71 23.89 +648 1 3.39 19.78 24.7 +649 1 5.42 23.52 1.93 +650 1 29.44 5.52 23.47 +651 1 23.83 22.25 20.16 +652 1 17.93 4.41 19.13 +653 1 9.44 1.91 29.19 +654 1 29.91 23.65 12.09 +655 1 27.06 21.35 3.96 +656 1 16.28 19.92 14.78 +657 1 19.99 5.38 17.54 +658 1 14.54 21.16 7.89 +659 1 26.09 14.97 10.68 +660 1 0.63 24.05 28.89 +661 1 5.07 25.73 10.62 +662 1 6.78 8.27 29.12 +663 1 11.86 12.77 15.67 +664 1 21.83 14.26 24.49 +665 1 23.7 1.53 6.32 +666 1 28.91 27.7 13.19 +667 1 16.46 28.92 23.22 +668 1 26.22 15.29 23.65 +669 1 23.75 1.5 21.21 +670 1 4.08 23.38 11.4 +671 1 29.4 29.73 2.7 +672 1 8.94 16.2 27.64 +673 1 30.79 23.65 6.33 +674 1 27.04 17.6 10.45 +675 1 21.48 15.71 29.11 +676 1 17.68 22.29 18.33 +677 1 22.1 29.54 1.71 +678 1 16.17 27.33 3.65 +679 1 9.22 5.24 5.71 +680 1 1.81 4.91 1.83 +681 1 30.98 28.61 5.42 +682 1 0.24 6.26 18.55 +683 1 17.39 24.85 11.97 +684 1 28.21 20.4 22.88 +685 1 23.01 8.35 29.39 +686 1 4.03 15.76 25.76 +687 1 3.89 12.75 4.32 +688 1 16.42 9.73 9.22 +689 1 14.74 17.01 13.68 +690 1 11.65 22.66 10.77 +691 1 21.04 26.56 25.76 +692 1 3.97 29.83 10.01 +693 1 10.62 26.12 25.57 +694 1 17.97 8.53 23.31 +695 1 19.22 16.46 13.24 +696 1 2.39 24.13 25.42 +697 1 1.72 21.99 14.71 +698 1 14.16 25.55 4.52 +699 1 10.58 12.26 13.38 +700 1 25.76 29.55 5.46 +701 1 24.18 1.25 26.8 +702 1 30.61 26.16 30.37 +703 1 3.38 16.05 28.52 +704 1 1.18 24.43 20.96 +705 1 7.9 1.26 25.66 +706 1 26.57 10.39 5.82 +707 1 8.44 8.09 16.34 +708 1 16.67 27.55 25.72 +709 1 7.45 2.82 7.35 +710 1 19.18 19.09 28.22 +711 1 12.68 8.88 30.58 +712 1 27.98 26.24 30.75 +713 1 11.84 28.3 20.75 +714 1 10.45 30.97 11.14 +715 1 8.96 2.33 11.92 +716 1 7.66 10.26 5.22 +717 1 23.5 12.98 28.85 +718 1 30.48 8.08 21.02 +719 1 16.48 29.96 10.33 +720 1 13.88 5.72 8.08 +721 1 27.47 28.22 21.47 +722 1 26.74 18.07 22.5 +723 1 25.13 23.78 0.9 +724 1 29.21 15.71 26.07 +725 1 19.41 3.92 10.58 +726 1 24.96 7.64 5.7 +727 1 7.44 14.1 29.85 +728 1 7.13 12.21 3.18 +729 1 16.35 14.7 4.18 +730 1 1.43 15.6 11.58 +731 1 30.27 1.93 9.17 +732 1 2.77 2.54 27.69 +733 1 11.36 27.83 16.39 +734 1 7.83 2.36 14.66 +735 1 19.3 12.28 5.63 +736 1 28.36 12.19 19.25 +737 1 10.67 7.34 13.62 +738 1 26.6 24.47 21.0 +739 1 8.55 29.42 27.3 +740 1 25.79 25.13 4.07 +741 1 28.21 8.09 22.88 +742 1 22.44 11.07 23.78 +743 1 27.76 17.89 25.74 +744 1 2.23 0.19 23.48 +745 1 10.49 12.99 20.29 +746 1 18.74 11.84 24.74 +747 1 29.46 2.69 24.54 +748 1 3.11 29.29 15.2 +749 1 21.8 19.07 20.45 +750 1 11.21 17.26 20.08 +751 1 2.59 26.55 26.79 +752 1 23.67 25.82 17.79 +753 1 23.43 27.91 15.08 +754 1 6.86 2.11 28.13 +755 1 14.38 19.97 19.61 +756 1 29.05 26.41 8.62 +757 1 3.34 9.63 6.81 +758 1 21.41 30.88 18.45 +759 1 30.35 16.75 23.77 +760 1 19.92 6.73 20.92 +761 1 26.4 1.5 11.47 +762 1 16.6 8.88 30.96 +763 1 23.25 29.76 4.34 +764 1 17.15 13.45 7.34 +765 1 14.52 14.34 23.37 +766 1 11.77 3.31 25.06 +767 1 15.52 25.25 0.94 +768 1 21.53 27.39 12.97 +769 1 11.29 10.11 17.38 +770 1 11.07 15.06 5.47 +771 1 27.61 7.39 6.07 +772 1 15.82 4.83 27.63 +773 1 17.16 20.28 12.25 +774 1 3.18 28.03 22.92 +775 1 25.53 27.61 25.22 +776 1 1.81 16.55 1.25 +777 1 3.72 16.82 7.97 +778 1 7.68 21.57 2.11 +779 1 21.85 26.93 28.36 +780 1 10.31 8.57 4.0 +781 1 11.61 9.88 14.35 +782 1 0.41 8.48 24.13 +783 1 3.8 10.63 30.74 +784 1 2.74 17.0 21.82 +785 1 28.44 22.73 28.74 +786 1 2.08 0.43 20.23 +787 1 0.25 9.36 2.02 +788 1 27.68 11.33 26.53 +789 1 27.63 4.1 14.74 +790 1 19.68 0.89 3.22 +791 1 17.12 30.74 17.17 +792 1 16.11 25.62 24.01 +793 1 20.49 9.58 13.85 +794 1 26.77 20.78 27.64 +795 1 18.77 16.87 25.93 +796 1 7.01 13.49 6.76 +797 1 18.38 16.84 18.4 +798 1 8.54 14.44 4.51 +799 1 11.51 1.42 8.98 +800 1 17.06 14.93 12.29 +801 1 6.07 0.24 15.08 +802 1 8.76 17.53 2.01 +803 1 19.63 6.58 1.71 +804 1 10.24 4.66 10.93 +805 1 4.39 20.15 30.88 +806 1 30.31 16.7 6.24 +807 1 26.0 30.16 27.34 +808 1 6.44 21.42 21.88 +809 1 22.05 29.62 11.43 +810 1 21.94 22.11 9.22 +811 1 21.82 1.59 13.13 +812 1 27.09 0.55 16.64 +813 1 8.88 3.09 17.06 +814 1 6.95 18.85 6.3 +815 1 20.13 2.53 15.07 +816 1 17.52 12.36 3.26 +817 1 18.46 7.24 13.99 +818 1 12.61 6.94 3.36 +819 1 15.55 17.46 19.11 +820 1 16.13 27.37 11.33 +821 1 2.99 14.41 9.34 +822 1 5.81 22.26 24.67 +823 1 19.82 2.53 6.19 +824 1 28.93 5.65 7.69 +825 1 17.89 22.05 15.68 +826 1 5.63 7.81 23.81 +827 1 19.09 16.3 22.05 +828 1 1.07 19.82 27.06 +829 1 14.74 8.15 28.71 +830 1 16.98 10.27 4.92 +831 1 13.39 20.01 5.47 +832 1 21.23 3.56 30.15 +833 1 29.23 18.12 28.24 +834 1 16.76 24.31 7.29 +835 1 26.12 21.8 21.5 +836 1 0.2 13.1 12.25 +837 1 1.99 3.78 30.39 +838 1 26.67 20.02 19.27 +839 1 20.63 10.01 5.91 +840 1 4.44 3.74 1.84 +841 1 21.95 6.78 0.24 +842 1 9.86 22.51 17.05 +843 1 26.17 7.64 18.91 +844 1 17.09 20.11 19.78 +845 1 10.38 9.07 9.16 +846 1 9.92 13.21 17.39 +847 1 24.26 19.17 3.05 +848 1 13.32 18.96 29.06 +849 1 27.98 20.32 7.7 +850 1 10.35 6.44 17.04 +851 1 27.27 28.95 29.77 +852 1 7.71 19.32 24.95 +853 1 23.11 17.51 14.39 +854 1 25.37 14.39 26.26 +855 1 4.73 3.99 17.92 +856 1 28.53 17.74 8.3 +857 1 28.99 9.49 7.65 +858 1 11.37 3.77 18.66 +859 1 11.01 23.57 6.0 +860 1 7.29 17.47 30.27 +861 1 18.92 10.24 0.36 +862 1 22.76 24.44 27.3 +863 1 14.27 13.05 5.04 +864 1 3.42 14.59 30.9 +865 1 9.31 22.34 24.75 +866 1 25.78 16.96 15.63 +867 1 7.18 22.01 12.25 +868 1 5.0 18.29 28.57 +869 1 23.36 20.87 22.7 +870 1 13.16 10.8 10.17 +871 1 6.42 24.78 7.47 +872 1 28.86 3.89 20.92 +873 1 4.8 3.05 13.07 +874 1 27.07 3.53 5.63 +875 1 13.11 28.33 23.92 +876 1 14.84 13.88 20.8 +877 1 15.81 7.0 16.91 +878 1 23.41 25.39 20.56 +879 1 26.08 0.43 14.19 +880 1 6.28 17.41 19.28 +881 1 2.74 4.79 19.54 +882 1 20.98 26.42 10.11 +883 1 24.18 28.48 29.18 +884 1 12.74 29.99 12.8 +885 1 27.22 16.82 18.13 +886 1 2.08 19.98 18.27 +887 1 22.0 23.67 17.16 +888 1 17.83 3.01 29.13 +889 1 9.59 26.62 13.51 +890 1 11.48 2.18 13.45 +891 1 13.57 15.29 26.47 +892 1 1.72 0.72 9.92 +893 1 2.14 30.76 17.27 +894 1 17.9 15.88 1.47 +895 1 13.47 5.84 28.76 +896 1 8.96 22.14 21.0 +897 1 12.96 24.15 0.94 +898 1 26.13 23.25 8.89 +899 1 6.01 28.65 6.08 +900 1 22.88 20.21 6.1 +901 1 30.34 20.77 10.49 +902 1 12.19 28.16 10.6 +903 1 5.8 5.33 30.84 +904 1 29.83 26.29 15.91 +905 1 18.28 0.14 5.58 +906 1 1.91 17.34 5.88 +907 1 24.05 18.42 22.53 +908 1 10.82 21.55 3.57 +909 1 11.29 26.73 5.6 +910 1 21.34 14.41 3.22 +911 1 12.61 18.99 24.17 +912 1 25.02 18.6 25.9 +913 1 29.0 21.05 13.14 +914 1 17.72 27.28 30.27 +915 1 30.56 24.81 23.12 +916 1 17.09 20.05 24.02 +917 1 7.35 6.83 21.31 +918 1 3.39 22.32 21.05 +919 1 2.28 29.8 30.23 +920 1 5.29 25.66 14.8 +921 1 26.16 30.72 21.04 +922 1 21.63 6.32 11.68 +923 1 15.45 18.06 4.65 +924 1 5.76 28.33 24.04 +925 1 15.08 29.21 16.09 +926 1 18.76 6.14 6.94 +927 1 22.31 30.25 26.46 +928 1 18.49 22.04 30.93 +929 1 11.15 16.42 9.89 +930 1 4.34 7.98 30.25 +931 1 9.29 29.92 8.58 +932 1 22.97 27.09 8.04 +933 1 20.71 16.7 15.75 +934 1 30.36 7.49 5.24 +935 1 29.56 19.54 0.83 +936 1 30.71 14.04 20.91 +937 1 19.36 4.06 27.14 +938 1 23.41 10.8 2.14 +939 1 1.51 1.32 0.44 +940 1 8.16 14.39 1.63 +941 1 20.66 6.74 4.62 +942 1 20.78 26.26 3.85 +943 1 5.11 15.12 21.64 +944 1 12.53 20.03 17.67 +945 1 28.63 18.4 12.56 +946 1 1.95 21.69 8.08 +947 1 21.53 0.93 7.84 +948 1 2.69 22.51 17.17 +949 1 19.29 22.12 6.05 +950 1 23.68 2.14 11.01 +951 1 27.14 17.8 3.72 +952 1 2.22 14.81 3.31 +953 1 23.1 6.43 14.62 +954 1 0.22 12.59 3.57 +955 1 13.21 22.86 3.67 +956 1 13.45 2.1 20.14 +957 1 12.52 17.12 0.46 +958 1 3.07 27.45 9.03 +959 1 15.33 10.95 11.78 +960 1 0.05 4.26 9.75 +961 1 23.05 16.98 24.69 +962 1 16.15 16.28 6.51 +963 1 30.05 28.87 9.61 +964 1 6.67 29.5 16.95 +965 1 21.95 14.44 14.94 +966 1 22.58 22.47 30.33 +967 1 21.34 19.29 9.9 +968 1 29.31 21.79 20.79 +969 1 5.55 2.56 30.23 +970 1 25.88 3.17 22.22 +971 1 22.38 18.32 30.08 +972 1 6.27 19.24 8.86 +973 1 0.34 24.29 1.49 +974 1 20.49 24.13 0.25 +975 1 2.94 1.41 2.74 +976 1 24.88 25.38 7.35 +977 1 28.18 14.89 14.6 +978 1 7.84 30.36 4.39 +979 1 14.54 9.59 14.4 +980 1 27.63 12.3 15.83 +981 1 11.15 14.17 27.97 +982 1 25.27 20.88 8.35 +983 1 17.06 14.76 27.78 +984 1 3.9 14.79 15.06 +985 1 13.81 3.82 17.03 +986 1 28.55 24.1 26.15 +987 1 29.28 21.79 15.76 +988 1 15.05 30.12 27.83 +989 1 15.42 3.77 6.76 +990 1 22.65 12.12 11.24 +991 1 11.29 4.96 2.18 +992 1 2.15 7.43 7.57 +993 1 30.21 10.13 26.21 +994 1 24.42 22.18 4.42 +995 1 8.68 14.72 22.08 +996 1 23.1 6.9 27.1 +997 1 18.71 27.2 21.72 +998 1 14.12 12.7 30.76 +999 1 18.81 6.5 10.98 +1000 1 26.66 15.4 4.83 diff --git a/examples/PACKAGES/pair_sw_3b_table/spce.in b/examples/PACKAGES/pair_sw_3b_table/spce.in new file mode 100644 index 0000000000..85303bf0d1 --- /dev/null +++ b/examples/PACKAGES/pair_sw_3b_table/spce.in @@ -0,0 +1,45 @@ +log none + +#SPC/E water + +units real +atom_style atomic + +read_data spce.data + +#hybrid pair style consisting of +#pair_style table to read in CG pair potential +#pair_style sw/table for tabulated sw interactions +pair_style hybrid/overlay table linear 1200 sw/3b/table + +#pair coefficients +pair_coeff 1 1 table table_CG_CG.txt VOTCA +pair_coeff * * sw/3b/table spce.sw type + +#nvt run with nose-hoover thermostat +#time coupling of 100 ts for thermostat +#target T is 300 K +fix 1 all nvt temp 300.0 300.0 200.0 + +#create initial velocities +velocity all create 300 432567 dist uniform +#remove center of mass linear momentum +velocity all zero linear + +#remove center of mass linear momentum every 1000 time steps in each cartesian direction +fix remove all momentum 1000 linear 1 1 1 + +#timestep of 2 fs +timestep 2.0 + +#print out thermodynamic info every 100 ts +thermo 100 + +#run 10000 ts +run 10000 + +#write out dump file every 10 ts for 100000 ts +dump 2 all custom 10 spce.dump id type x y z fx fy fz +run 100000 + +undump 2 diff --git a/examples/PACKAGES/pair_sw_3b_table/spce.sw b/examples/PACKAGES/pair_sw_3b_table/spce.sw new file mode 100644 index 0000000000..8b0fd70f61 --- /dev/null +++ b/examples/PACKAGES/pair_sw_3b_table/spce.sw @@ -0,0 +1,18 @@ +type +type +type +1 #epsilon in kcal/mol +1 #sigma in dimensionless +3.7 # a in Ang +1.0 #lambda dimensionless +0.8 #gamma in Ang +0.0 #costheta0 dimensionless +0 #two body part A=0 +0 #two body part B=0 +0 #two body part p=0 +0 #two body part q=0 +0.0 # use the standard Stillinger-Weber cutoff +table_CG_CG_CG.txt +VOTCA +linear +1001 diff --git a/examples/PACKAGES/pair_sw_3b_table/table_CG_CG.txt b/examples/PACKAGES/pair_sw_3b_table/table_CG_CG.txt new file mode 100644 index 0000000000..f4ccdd4b4e --- /dev/null +++ b/examples/PACKAGES/pair_sw_3b_table/table_CG_CG.txt @@ -0,0 +1,1203 @@ +VOTCA +N 1200 R 0.010000 12.000000 + +1 1.0000000000e-02 1.5390100510e+15 2.1517330910e+16 +2 2.0000000000e-02 1.3370836560e+15 1.8774943350e+16 +3 3.0000000000e-02 1.1616510900e+15 1.6231560530e+16 +4 4.0000000000e-02 1.0092362200e+15 1.4101892510e+16 +5 5.0000000000e-02 8.7681900090e+14 1.2251648380e+16 +6 6.0000000000e-02 7.6177563290e+14 1.0644166230e+16 +7 7.0000000000e-02 6.6182657340e+14 9.2475943770e+15 +8 8.0000000000e-02 5.7499136800e+14 8.0342602660e+15 +9 9.0000000000e-02 4.9954940840e+14 6.9801221150e+15 +10 1.0000000000e-01 4.3400583970e+14 6.0642925570e+15 +11 1.1000000000e-01 3.7706193970e+14 5.2686247630e+15 +12 1.2000000000e-01 3.2758938550e+14 4.5773528620e+15 +13 1.3000000000e-01 2.8460789650e+14 3.9767795520e+15 +14 1.4000000000e-01 2.4726581000e+14 3.4550046890e+15 +15 1.5000000000e-01 2.1482320610e+14 3.0016894950e+15 +16 1.6000000000e-01 1.8663724620e+14 2.6078516910e+15 +17 1.7000000000e-01 1.6214943590e+14 2.2656875260e+15 +18 1.8000000000e-01 1.4087455790e+14 1.9684171380e+15 +19 1.9000000000e-01 1.2239105840e+14 1.7101502250e+15 +20 2.0000000000e-01 1.0633269330e+14 1.4857693190e+15 +21 2.1000000000e-01 9.2381272170e+13 1.2908283940e+15 +22 2.2000000000e-01 8.0260352480e+13 1.1214647680e+15 +23 2.3000000000e-01 6.9729762630e+13 9.7432255940e+14 +24 2.4000000000e-01 6.0580842800e+13 8.4648620020e+14 +25 2.5000000000e-01 5.2632310450e+13 7.3542265870e+14 +26 2.6000000000e-01 4.5726668290e+13 6.3893125110e+14 +27 2.7000000000e-01 3.9727083510e+13 5.5510003510e+14 +28 2.8000000000e-01 3.4514676520e+13 4.8226792540e+14 +29 2.9000000000e-01 2.9986165360e+13 4.1899178020e+14 +30 3.0000000000e-01 2.6051819210e+13 3.6401780550e+14 +31 3.1000000000e-01 2.2633680440e+13 3.1625671190e+14 +32 3.2000000000e-01 1.9664019850e+13 2.7476213060e+14 +33 3.3000000000e-01 1.7083994700e+13 2.3871186160e+14 +34 3.4000000000e-01 1.4842482730e+13 2.0739158160e+14 +35 3.5000000000e-01 1.2895069180e+13 1.8018069090e+14 +36 3.6000000000e-01 1.1203166760e+13 1.5654001530e+14 +37 3.7000000000e-01 9.7332510350e+12 1.3600112350e+14 +38 3.8000000000e-01 8.4561961580e+12 1.1815704470e+14 +39 3.9000000000e-01 7.3466977490e+12 1.0265420510e+14 +40 4.0000000000e-01 6.3827714970e+12 8.9185421350e+13 +41 4.1000000000e-01 5.5453175530e+12 7.7483814470e+13 +42 4.2000000000e-01 4.8177420700e+12 6.7317521340e+13 +43 4.3000000000e-01 4.1856284030e+12 5.8485100540e+13 +44 4.4000000000e-01 3.6364514480e+12 5.0811540850e+13 +45 4.5000000000e-01 3.1593294630e+12 4.4144793450e+13 +46 4.6000000000e-01 2.7448084480e+12 3.8352759160e+13 +47 4.7000000000e-01 2.3846748190e+12 3.3320670910e+13 +48 4.8000000000e-01 2.0717926600e+12 2.8948819710e+13 +49 4.9000000000e-01 1.7999623210e+12 2.5150578890e+13 +50 5.0000000000e-01 1.5637975860e+12 2.1850687690e+13 +51 5.1000000000e-01 1.3586189330e+12 1.8983759960e+13 +52 5.2000000000e-01 1.1803608230e+12 1.6492988570e+13 +53 5.3000000000e-01 1.0254911360e+12 1.4329019780e+13 +54 5.4000000000e-01 8.9094118400e+11 1.2448975330e+13 +55 5.5000000000e-01 7.7404490960e+11 1.0815602820e+13 +56 5.6000000000e-01 6.7248605500e+11 9.3965375690e+12 +57 5.7000000000e-01 5.8425226830e+11 8.1636613100e+12 +58 5.8000000000e-01 5.0759522880e+11 7.0925450460e+12 +59 5.9000000000e-01 4.4099600520e+11 6.1619649960e+12 +60 6.0000000000e-01 3.8313495790e+11 5.3534820520e+12 +61 6.1000000000e-01 3.3286559110e+11 4.6510764180e+12 +62 6.2000000000e-01 2.8919183550e+11 4.0408301810e+12 +63 6.3000000000e-01 2.5124831160e+11 3.5106515320e+12 +64 6.4000000000e-01 2.1828318200e+11 3.0500351720e+12 +65 6.5000000000e-01 1.8964325470e+11 2.6498541560e+12 +66 6.6000000000e-01 1.6476103990e+11 2.3021790410e+12 +67 6.7000000000e-01 1.4314350540e+11 2.0001207710e+12 +68 6.8000000000e-01 1.2436230780e+11 1.7376941700e+12 +69 6.9000000000e-01 1.0804530420e+11 1.5096993500e+12 +70 7.0000000000e-01 9.3869179290e+10 1.3116186770e+12 +71 7.1000000000e-01 8.1553038190e+10 1.1395272530e+12 +72 7.2000000000e-01 7.0852841020e+10 9.9001514990e+11 +73 7.3000000000e-01 6.1556567270e+10 8.6011983840e+11 +74 7.4000000000e-01 5.3480014620e+10 7.4726749030e+11 +75 7.5000000000e-01 4.6463149110e+10 6.4922197710e+11 +76 7.6000000000e-01 4.0366934090e+10 5.6404056250e+11 +77 7.7000000000e-01 3.5070575270e+10 4.9003540760e+11 +78 7.8000000000e-01 3.0469127200e+10 4.2574012690e+11 +79 7.9000000000e-01 2.6471413860e+10 3.6988073290e+11 +80 8.0000000000e-01 2.2998222010e+10 3.2135039170e+11 +81 8.1000000000e-01 1.9980731610e+10 2.7918749220e+11 +82 8.2000000000e-01 1.7359152180e+10 2.4255659190e+11 +83 8.3000000000e-01 1.5081538060e+10 2.1073186270e+11 +84 8.4000000000e-01 1.3102759170e+10 1.8308270910e+11 +85 8.5000000000e-01 1.1383606700e+10 1.5906127310e+11 +86 8.6000000000e-01 9.8900162880e+09 1.3819157870e+11 +87 8.7000000000e-01 8.5923929670e+09 1.2006010050e+11 +88 8.8000000000e-01 7.4650248040e+09 1.0430756970e+11 +89 8.9000000000e-01 6.4855734070e+09 9.0621855610e+10 +90 9.0000000000e-01 5.6346312990e+09 7.8731780830e+10 +91 9.1000000000e-01 4.8953373730e+09 6.8401747800e+10 +92 9.2000000000e-01 4.2530427840e+09 5.9427070660e+10 +93 9.3000000000e-01 3.6950207000e+09 5.1629919420e+10 +94 9.4000000000e-01 3.2102141140e+09 4.4855796350e+10 +95 9.5000000000e-01 2.7890167600e+09 3.8970474660e+10 +96 9.6000000000e-01 2.4230827630e+09 3.3857338820e+10 +97 9.7000000000e-01 2.1051612740e+09 2.9415073900e+10 +98 9.8000000000e-01 1.8289527940e+09 2.5555658020e+10 +99 9.9000000000e-01 1.5889843520e+09 2.2202618260e+10 +100 1.0000000000e+00 1.3805010610e+09 1.9289515350e+10 +101 1.0100000000e+00 1.1993718980e+09 1.6758627210e+10 +102 1.0200000000e+00 1.0420078550e+09 1.4559805200e+10 +103 1.0300000000e+00 9.0529082110e+08 1.2649480460e+10 +104 1.0400000000e+00 7.8651179720e+08 1.0989800600e+10 +105 1.0500000000e+00 6.8331721990e+08 9.5478796640e+09 +106 1.0600000000e+00 5.9366232610e+08 8.2951465080e+09 +107 1.0700000000e+00 5.1577063650e+08 7.2067786790e+09 +108 1.0800000000e+00 4.4809875540e+08 6.2612105610e+09 +109 1.0900000000e+00 3.8930578900e+08 5.4397060660e+09 +110 1.1000000000e+00 3.3822677600e+08 4.7259873780e+09 +111 1.1100000000e+00 2.9384960420e+08 4.1059124200e+09 +112 1.1200000000e+00 2.5529495590e+08 3.5671946310e+09 +113 1.1300000000e+00 2.2179888490e+08 3.0991595130e+09 +114 1.1400000000e+00 1.9269767840e+08 2.6925331190e+09 +115 1.1500000000e+00 1.6741470680e+08 2.3392582940e+09 +116 1.1600000000e+00 1.4544899700e+08 2.0323350270e+09 +117 1.1700000000e+00 1.2636530640e+08 1.7656817420e+09 +118 1.1800000000e+00 1.0978549870e+08 1.5340148030e+09 +119 1.1900000000e+00 9.5381050880e+07 1.3327438110e+09 +120 1.2000000000e+00 8.2866544090e+07 1.1578806560e+09 +121 1.2100000000e+00 7.1994007890e+07 1.0059604880e+09 +122 1.2200000000e+00 6.2548006910e+07 8.7397306220e+08 +123 1.2300000000e+00 5.4341372050e+07 7.5930309660e+08 +124 1.2400000000e+00 4.7211491810e+07 6.5967844720e+08 +125 1.2500000000e+00 4.1017090210e+07 5.7312508750e+08 +126 1.2600000000e+00 3.5635427400e+07 4.9792799400e+08 +127 1.2700000000e+00 3.0959867700e+07 4.3259716360e+08 +128 1.2800000000e+00 2.6897766570e+07 3.7583808940e+08 +129 1.2900000000e+00 2.3368634950e+07 3.2652611100e+08 +130 1.3000000000e+00 2.0302544380e+07 2.8368412930e+08 +131 1.3100000000e+00 1.7638741380e+07 2.4646324610e+08 +132 1.3200000000e+00 1.5324443660e+07 2.1412594280e+08 +133 1.3300000000e+00 1.3313794240e+07 1.8603146760e+08 +134 1.3400000000e+00 1.1566952840e+07 1.6162313870e+08 +135 1.3500000000e+00 1.0049306430e+07 1.4041731380e+08 +136 1.3600000000e+00 8.7307833840e+06 1.2199380710e+08 +137 1.3700000000e+00 7.5852576540e+06 1.0598756360e+08 +138 1.3800000000e+00 6.5900310600e+06 9.2081425300e+07 +139 1.3900000000e+00 5.7253835470e+06 7.9999847130e+07 +140 1.4000000000e+00 4.9741824370e+06 6.9503436980e+07 +141 1.4100000000e+00 4.3215429520e+06 6.0384212290e+07 +142 1.4200000000e+00 3.7545332780e+06 5.2461478920e+07 +143 1.4300000000e+00 3.2619183220e+06 4.5578250780e+07 +144 1.4400000000e+00 2.8339370970e+06 3.9598139180e+07 +145 1.4500000000e+00 2.4621093100e+06 3.4402650380e+07 +146 1.4600000000e+00 2.1390673290e+06 2.9888837650e+07 +147 1.4700000000e+00 1.8584101920e+06 2.5967261420e+07 +148 1.4800000000e+00 1.6145767810e+06 2.2560217080e+07 +149 1.4900000000e+00 1.4027356250e+06 1.9600195280e+07 +150 1.5000000000e+00 1.2186891680e+06 1.7028544260e+07 +151 1.5100000000e+00 1.0587905960e+06 1.4794307680e+07 +152 1.5200000000e+00 9.1987157580e+05 1.2853214960e+07 +153 1.5300000000e+00 7.9917947840e+05 1.1166804040e+07 +154 1.5400000000e+00 6.9432283320e+05 9.7016592970e+06 +155 1.5500000000e+00 6.0322394380e+05 8.4287494270e+06 +156 1.5600000000e+00 5.2407771850e+05 7.3228521760e+06 +157 1.5700000000e+00 4.5531590360e+05 6.3620545920e+06 +158 1.5800000000e+00 3.9557600860e+05 5.5273188170e+06 +159 1.5900000000e+00 3.4367430900e+05 4.8021048650e+06 +160 1.6000000000e+00 2.9858239160e+05 4.1720428830e+06 +161 1.6100000000e+00 2.5940677620e+05 3.6246484220e+06 +162 1.6200000000e+00 2.2537121220e+05 3.1490750570e+06 +163 1.6300000000e+00 1.9580129720e+05 2.7358994750e+06 +164 1.6400000000e+00 1.7011111410e+05 2.3769347520e+06 +165 1.6500000000e+00 1.4779162110e+05 2.0650681300e+06 +166 1.6600000000e+00 1.2840056570e+05 1.7941200870e+06 +167 1.6700000000e+00 1.1155372100e+05 1.5587218830e+06 +168 1.6800000000e+00 9.6917272910e+04 1.3542091900e+06 +169 1.6900000000e+00 8.4201205530e+04 1.1765296620e+06 +170 1.7000000000e+00 7.3153554570e+04 1.0221626440e+06 +171 1.7100000000e+00 6.3555414830e+04 8.8804940820e+05 +172 1.7200000000e+00 5.5216602630e+04 7.7153255030e+05 +173 1.7300000000e+00 4.7971887440e+04 6.7030333080e+05 +174 1.7400000000e+00 4.1677717830e+04 5.8235592920e+05 +175 1.7500000000e+00 3.6209377130e+04 5.0594769970e+05 +176 1.7600000000e+00 3.1458512140e+04 4.3956464070e+05 +177 1.7700000000e+00 2.7330986170e+04 3.8189139610e+05 +178 1.7800000000e+00 2.3745013820e+04 3.3178519130e+05 +179 1.7900000000e+00 2.0629540310e+04 2.8825319000e+05 +180 1.8000000000e+00 1.7922833690e+04 2.5043282140e+05 +181 1.8100000000e+00 1.5571261530e+04 2.1757468850e+05 +182 1.8200000000e+00 1.3528228280e+04 1.8902771940e+05 +183 1.8300000000e+00 1.1753251980e+04 1.6422626610e+05 +184 1.8400000000e+00 1.0211162120e+04 1.4267889680e+05 +185 1.8500000000e+00 8.8714027380e+03 1.2395865830e+05 +186 1.8600000000e+00 7.7074269920e+03 1.0769461580e+05 +187 1.8700000000e+00 6.6961711240e+03 9.3564503040e+04 +188 1.8800000000e+00 5.8175974640e+03 8.1288337100e+04 +189 1.8900000000e+00 5.0542973920e+03 7.0622870140e+04 +190 1.9000000000e+00 4.3911463950e+03 6.1356769800e+04 +191 1.9100000000e+00 3.8150043740e+03 5.3306431660e+04 +192 1.9200000000e+00 3.3144552850e+03 4.6312341170e+04 +193 1.9300000000e+00 2.8795809280e+03 4.0235912960e+04 +194 1.9400000000e+00 2.5017644250e+03 3.4956744810e+04 +195 1.9500000000e+00 2.1735194790e+03 3.0370231910e+04 +196 1.9600000000e+00 1.8883420360e+03 2.6385494170e+04 +197 1.9700000000e+00 1.6405814060e+03 2.2923575440e+04 +198 1.9800000000e+00 1.4253283030e+03 1.9915879070e+04 +199 1.9900000000e+00 1.2383175650e+03 1.7302808640e+04 +200 2.0000000000e+00 1.0758436410e+03 1.5032587100e+04 +201 2.0100000000e+00 9.3468717030e+02 1.3060230840e+04 +202 2.0200000000e+00 8.1205118730e+02 1.1346658320e+04 +203 2.0300000000e+00 7.0550570470e+02 9.8579157300e+03 +204 2.0400000000e+00 6.1293956240e+02 8.5645041750e+03 +205 2.0500000000e+00 5.3251859570e+02 7.4407951710e+03 +206 2.0600000000e+00 4.6264929230e+02 6.4645228320e+03 +207 2.0700000000e+00 4.0194721720e+02 5.6163426730e+03 +208 2.0800000000e+00 3.4920958090e+02 4.8794483120e+03 +209 2.0900000000e+00 3.0339140600e+02 4.2392384540e+03 +210 2.1000000000e+00 2.6358482200e+02 3.6830275730e+03 +211 2.1100000000e+00 2.2900107590e+02 3.1997945490e+03 +212 2.1200000000e+00 1.9895490330e+02 2.7799642980e+03 +213 2.1300000000e+00 1.7285095010e+02 2.4152180320e+03 +214 2.1400000000e+00 1.5017197590e+02 2.0983284390e+03 +215 2.1500000000e+00 1.3046860510e+02 1.8230164640e+03 +216 2.1600000000e+00 1.1335042260e+02 1.5838269000e+03 +217 2.1700000000e+00 9.8478237570e+01 1.3760202940e+03 +218 2.1800000000e+00 8.5557363230e+01 1.1954790320e+03 +219 2.1900000000e+00 7.4331777090e+01 1.0386257540e+03 +220 2.2000000000e+00 6.4579048210e+01 9.0235246990e+02 +221 2.2100000000e+00 5.6105929810e+01 7.8395897350e+02 +222 2.2200000000e+00 4.8744530110e+01 6.8109934040e+02 +223 2.2300000000e+00 4.2348985630e+01 5.9173544430e+02 +224 2.2400000000e+00 3.6792570990e+01 5.1409657190e+02 +225 2.2500000000e+00 3.1965187820e+01 4.4664433710e+02 +226 2.2600000000e+00 2.7771183280e+01 3.8804219830e+02 +227 2.2700000000e+00 2.4127454700e+01 3.3712897510e+02 +228 2.2800000000e+00 2.0961802900e+01 2.9289584070e+02 +229 2.2900000000e+00 1.8211501630e+01 2.5446633130e+02 +230 2.3000000000e+00 1.5822054690e+01 2.2107898030e+02 +231 2.3100000000e+00 1.3746116030e+01 1.9207222920e+02 +232 2.3200000000e+00 1.1942551680e+01 1.6687131990e+02 +233 2.3300000000e+00 1.0375624680e+01 1.4497690530e+02 +234 2.3400000000e+00 9.0142869290e+00 1.2595515570e+02 +235 2.3500000000e+00 7.8315640090e+00 1.0942916200e+02 +236 2.3600000000e+00 6.8040206970e+00 9.5071467470e+01 +237 2.3700000000e+00 5.9112965930e+00 8.2597579690e+01 +238 2.3800000000e+00 5.1357026910e+00 7.1760333060e+01 +239 2.3900000000e+00 4.4618708810e+00 6.2344991470e+01 +240 2.4000000000e+00 3.8764494280e+00 5.3036352210e+01 +241 2.4100000000e+00 3.3678384170e+00 4.8261295350e+01 +242 2.4200000000e+00 2.8941569300e+00 4.5857614440e+01 +243 2.4300000000e+00 2.4468631800e+00 4.3406963180e+01 +244 2.4400000000e+00 2.0256587860e+00 4.0812932280e+01 +245 2.4500000000e+00 1.6301260100e+00 3.8266641770e+01 +246 2.4600000000e+00 1.2597277660e+00 3.5780026500e+01 +247 2.4700000000e+00 9.1380761130e-01 3.3365021740e+01 +248 2.4800000000e+00 5.9158975140e-01 3.1033562180e+01 +249 2.4900000000e+00 2.9217903890e-01 2.8797954450e+01 +250 2.5000000000e+00 1.4560973470e-02 2.6671263930e+01 +251 2.5100000000e+00 -2.4238415820e-01 2.4661823870e+01 +252 2.5200000000e+00 -4.7981058030e-01 2.2768039630e+01 +253 2.5300000000e+00 -6.9883632600e-01 2.0983874620e+01 +254 2.5400000000e+00 -9.0052909770e-01 1.9303963110e+01 +255 2.5500000000e+00 -1.0859062660e+00 1.7723272100e+01 +256 2.5600000000e+00 -1.2559348720e+00 1.6236768280e+01 +257 2.5700000000e+00 -1.4115316230e+00 1.4839418560e+01 +258 2.5800000000e+00 -1.5535628980e+00 1.3526189880e+01 +259 2.5900000000e+00 -1.6828447430e+00 1.2292001960e+01 +260 2.6000000000e+00 -1.8001428730e+00 1.1131681390e+01 +261 2.6100000000e+00 -1.9061744430e+00 1.0040648660e+01 +262 2.6200000000e+00 -2.0016168960e+00 9.0155628370e+00 +263 2.6300000000e+00 -2.0871168150e+00 8.0536395060e+00 +264 2.6400000000e+00 -2.1632916940e+00 7.1520107860e+00 +265 2.6500000000e+00 -2.2307299330e+00 6.3077675390e+00 +266 2.6600000000e+00 -2.2899908440e+00 5.5180009250e+00 +267 2.6700000000e+00 -2.3416046480e+00 4.7798017190e+00 +268 2.6800000000e+00 -2.3860724750e+00 4.0902608440e+00 +269 2.6900000000e+00 -2.4238663650e+00 3.4464440960e+00 +270 2.7000000000e+00 -2.4554292680e+00 2.8453664940e+00 +271 2.7100000000e+00 -2.4811759890e+00 2.2843626470e+00 +272 2.7200000000e+00 -2.5014979300e+00 1.7614298710e+00 +273 2.7300000000e+00 -2.5167678200e+00 1.2748621430e+00 +274 2.7400000000e+00 -2.5273406710e+00 8.2290948110e-01 +275 2.7500000000e+00 -2.5335537710e+00 4.0379949770e-01 +276 2.7600000000e+00 -2.5357266870e+00 1.5760010280e-02 +277 2.7700000000e+00 -2.5341612640e+00 -3.4298090310e-01 +278 2.7800000000e+00 -2.5291416280e+00 -6.7419561340e-01 +279 2.7900000000e+00 -2.5209341800e+00 -9.7967404420e-01 +280 2.8000000000e+00 -2.5097876030e+00 -1.2612416950e+00 +281 2.8100000000e+00 -2.4959335160e+00 -1.5205003860e+00 +282 2.8200000000e+00 -2.4795897790e+00 -1.7585895080e+00 +283 2.8300000000e+00 -2.4609637910e+00 -1.9764437290e+00 +284 2.8400000000e+00 -2.4402531510e+00 -2.1750280650e+00 +285 2.8500000000e+00 -2.4176456570e+00 -2.3553224700e+00 +286 2.8600000000e+00 -2.3933193080e+00 -2.5183069580e+00 +287 2.8700000000e+00 -2.3674423020e+00 -2.6649614780e+00 +288 2.8800000000e+00 -2.3401730380e+00 -2.7962661310e+00 +289 2.8900000000e+00 -2.3116601130e+00 -2.9132049510e+00 +290 2.9000000000e+00 -2.2820423250e+00 -3.0167697150e+00 +291 2.9100000000e+00 -2.2514488140e+00 -3.1079034930e+00 +292 2.9200000000e+00 -2.2199997690e+00 -3.1874493890e+00 +293 2.9300000000e+00 -2.1878071410e+00 -3.2562082020e+00 +294 2.9400000000e+00 -2.1549747780e+00 -3.3149866360e+00 +295 2.9500000000e+00 -2.1215984330e+00 -3.3645944150e+00 +296 2.9600000000e+00 -2.0877657580e+00 -3.4058413510e+00 +297 2.9700000000e+00 -2.0535563080e+00 -3.4395371300e+00 +298 2.9800000000e+00 -2.0190415380e+00 -3.4664917760e+00 +299 2.9900000000e+00 -1.9842848030e+00 -3.4875215040e+00 +300 3.0000000000e+00 -1.9493413610e+00 -3.5034563820e+00 +301 3.0100000000e+00 -1.9142585830e+00 -3.5150471190e+00 +302 3.0200000000e+00 -1.8790770150e+00 -3.5228910160e+00 +303 3.0300000000e+00 -1.8438314390e+00 -3.5275214590e+00 +304 3.0400000000e+00 -1.8085510860e+00 -3.5289583340e+00 +305 3.0500000000e+00 -1.7732596360e+00 -3.5288908310e+00 +306 3.0600000000e+00 -1.7379752190e+00 -3.5280320940e+00 +307 3.0700000000e+00 -1.7027104110e+00 -3.5253862790e+00 +308 3.0800000000e+00 -1.6674722390e+00 -3.5223395310e+00 +309 3.0900000000e+00 -1.6322621780e+00 -3.5194378970e+00 +310 3.1000000000e+00 -1.5970761530e+00 -3.5173081740e+00 +311 3.1100000000e+00 -1.5619051030e+00 -3.5168447480e+00 +312 3.1200000000e+00 -1.5267378260e+00 -3.5168563320e+00 +313 3.1300000000e+00 -1.4915638140e+00 -3.5177518380e+00 +314 3.1400000000e+00 -1.4563738200e+00 -3.5198200760e+00 +315 3.1500000000e+00 -1.4211598630e+00 -3.5226190880e+00 +316 3.1600000000e+00 -1.3859152220e+00 -3.5260255420e+00 +317 3.1700000000e+00 -1.3506344420e+00 -3.5299136690e+00 +318 3.1800000000e+00 -1.3153133290e+00 -3.5341578930e+00 +319 3.1900000000e+00 -1.2799489510e+00 -3.5386343920e+00 +320 3.2000000000e+00 -1.2445396420e+00 -3.5432253600e+00 +321 3.2100000000e+00 -1.2090851000e+00 -3.5477800910e+00 +322 3.2200000000e+00 -1.1735869120e+00 -3.5520723480e+00 +323 3.2300000000e+00 -1.1380490760e+00 -3.5558443110e+00 +324 3.2400000000e+00 -1.1024780970e+00 -3.5588459720e+00 +325 3.2500000000e+00 -1.0668829990e+00 -3.5606965620e+00 +326 3.2600000000e+00 -1.0312753150e+00 -3.5607083610e+00 +327 3.2700000000e+00 -9.9566909100e-01 -3.5605541570e+00 +328 3.2800000000e+00 -9.6008088680e-01 -3.5579489480e+00 +329 3.2900000000e+00 -9.2452977440e-01 -3.5533045150e+00 +330 3.3000000000e+00 -8.8903733850e-01 -3.5464131370e+00 +331 3.3100000000e+00 -8.5362827280e-01 -3.5368973480e+00 +332 3.3200000000e+00 -8.1833336060e-01 -3.5239572210e+00 +333 3.3300000000e+00 -7.8319245590e-01 -3.5065687200e+00 +334 3.3400000000e+00 -7.4825507930e-01 -3.4837450990e+00 +335 3.3500000000e+00 -7.1358041810e-01 -3.4545190770e+00 +336 3.3600000000e+00 -6.7923732650e-01 -3.4179238010e+00 +337 3.3700000000e+00 -6.4530432520e-01 -3.3729926040e+00 +338 3.3800000000e+00 -6.1186960170e-01 -3.3187588290e+00 +339 3.3900000000e+00 -5.7903101040e-01 -3.2542297980e+00 +340 3.4000000000e+00 -5.4689607220e-01 -3.1783580730e+00 +341 3.4100000000e+00 -5.1558072820e-01 -3.0904661310e+00 +342 3.4200000000e+00 -4.8520310790e-01 -2.9907576290e+00 +343 3.4300000000e+00 -4.5587729660e-01 -2.8798705460e+00 +344 3.4400000000e+00 -4.2771208900e-01 -2.7583688810e+00 +345 3.4500000000e+00 -4.0081098950e-01 -2.6267815840e+00 +346 3.4600000000e+00 -3.7527221170e-01 -2.4856376550e+00 +347 3.4700000000e+00 -3.5118867890e-01 -2.3354660560e+00 +348 3.4800000000e+00 -3.2864802400e-01 -2.1767958410e+00 +349 3.4900000000e+00 -3.0773258900e-01 -2.0101012320e+00 +350 3.5000000000e+00 -2.8851942590e-01 -1.8357436110e+00 +351 3.5100000000e+00 -2.7107800890e-01 -1.6548080920e+00 +352 3.5200000000e+00 -2.5545880110e-01 -1.4699936560e+00 +353 3.5300000000e+00 -2.4168181970e-01 -1.2847553720e+00 +354 3.5400000000e+00 -2.2973434990e-01 -1.1024244830e+00 +355 3.5500000000e+00 -2.1957094400e-01 -9.2627328940e-01 +356 3.5600000000e+00 -2.1111342220e-01 -7.5957368970e-01 +357 3.5700000000e+00 -2.0425087220e-01 -6.0559684560e-01 +358 3.5800000000e+00 -1.9883964940e-01 -4.6761229440e-01 +359 3.5900000000e+00 -1.9470337660e-01 -3.4905079620e-01 +360 3.6000000000e+00 -1.9163294430e-01 -2.5373424880e-01 +361 3.6100000000e+00 -1.8939187810e-01 -1.8353921730e-01 +362 3.6200000000e+00 -1.8774317600e-01 -1.3643213030e-01 +363 3.6300000000e+00 -1.8647614590e-01 -1.0900277830e-01 +364 3.6400000000e+00 -1.8541177300e-01 -1.0217451770e-01 +365 3.6500000000e+00 -1.8440272000e-01 -1.0257729120e-01 +366 3.6600000000e+00 -1.8333332690e-01 -1.1032823210e-01 +367 3.6700000000e+00 -1.8211961100e-01 -1.2921992570e-01 +368 3.6800000000e+00 -1.8070926700e-01 -1.5163890710e-01 +369 3.6900000000e+00 -1.7908166700e-01 -1.7442524050e-01 +370 3.7000000000e+00 -1.7724786040e-01 -1.9407009560e-01 +371 3.7100000000e+00 -1.7524726610e-01 -2.0823224750e-01 +372 3.7200000000e+00 -1.7313113340e-01 -2.1707301960e-01 +373 3.7300000000e+00 -1.7094600210e-01 -2.2155931460e-01 +374 3.7400000000e+00 -1.6873039540e-01 -2.2155890460e-01 +375 3.7500000000e+00 -1.6651481940e-01 -2.2155573260e-01 +376 3.7600000000e+00 -1.6432176310e-01 -2.1804279820e-01 +377 3.7700000000e+00 -1.6216569890e-01 -2.1356882610e-01 +378 3.7800000000e+00 -1.6005308190e-01 -2.0885944940e-01 +379 3.7900000000e+00 -1.5798235030e-01 -2.0472213750e-01 +380 3.8000000000e+00 -1.5594392560e-01 -2.0241705720e-01 +381 3.8100000000e+00 -1.5392117290e-01 -2.0241827750e-01 +382 3.8200000000e+00 -1.5189520660e-01 -2.0277318370e-01 +383 3.8300000000e+00 -1.4984969490e-01 -2.0558456320e-01 +384 3.8400000000e+00 -1.4777182060e-01 -2.0947681570e-01 +385 3.8500000000e+00 -1.4565228170e-01 -2.1411724290e-01 +386 3.8600000000e+00 -1.4348529090e-01 -2.1915859900e-01 +387 3.8700000000e+00 -1.4126857580e-01 -2.2425124170e-01 +388 3.8800000000e+00 -1.3900337870e-01 -2.2904532330e-01 +389 3.8900000000e+00 -1.3669445690e-01 -2.3317711800e-01 +390 3.9000000000e+00 -1.3435008260e-01 -2.3624008380e-01 +391 3.9100000000e+00 -1.3198159090e-01 -2.3798596650e-01 +392 3.9200000000e+00 -1.2960112040e-01 -2.3812682950e-01 +393 3.9300000000e+00 -1.2721935400e-01 -2.3811467960e-01 +394 3.9400000000e+00 -1.2484506660e-01 -2.3702815340e-01 +395 3.9500000000e+00 -1.2248512560e-01 -2.3523949930e-01 +396 3.9600000000e+00 -1.2014449050e-01 -2.3305519030e-01 +397 3.9700000000e+00 -1.1782621320e-01 -2.3066255720e-01 +398 3.9800000000e+00 -1.1553143760e-01 -2.2825101140e-01 +399 3.9900000000e+00 -1.1325940020e-01 -2.2601755080e-01 +400 4.0000000000e+00 -1.1100742940e-01 -2.2417862310e-01 +401 4.0100000000e+00 -1.0877118630e-01 -2.2286349760e-01 +402 4.0200000000e+00 -1.0654586480e-01 -2.2202230410e-01 +403 4.0300000000e+00 -1.0432739300e-01 -2.2154405680e-01 +404 4.0400000000e+00 -1.0211267260e-01 -2.2132766590e-01 +405 4.0500000000e+00 -9.9899579570e-02 -2.2126903570e-01 +406 4.0600000000e+00 -9.7686963680e-02 -2.2125247670e-01 +407 4.0700000000e+00 -9.5474648740e-02 -2.2122106790e-01 +408 4.0800000000e+00 -9.3263432500e-02 -2.2107465710e-01 +409 4.0900000000e+00 -9.1055086710e-02 -2.2070112830e-01 +410 4.1000000000e+00 -8.8852357090e-02 -2.1999541830e-01 +411 4.1100000000e+00 -8.6658837090e-02 -2.1888407060e-01 +412 4.1200000000e+00 -8.4478336830e-02 -2.1738813900e-01 +413 4.1300000000e+00 -8.2314251940e-02 -2.1557604180e-01 +414 4.1400000000e+00 -8.0169437390e-02 -2.1350571680e-01 +415 4.1500000000e+00 -7.8046207450e-02 -2.1123112730e-01 +416 4.1600000000e+00 -7.5946335690e-02 -2.0880628380e-01 +417 4.1700000000e+00 -7.3871055030e-02 -2.0628522250e-01 +418 4.1800000000e+00 -7.1821057660e-02 -2.0372199140e-01 +419 4.1900000000e+00 -6.9796495110e-02 -2.0117226580e-01 +420 4.2000000000e+00 -6.7796978220e-02 -1.9869515570e-01 +421 4.2100000000e+00 -6.5821640000e-02 -1.9632881020e-01 +422 4.2200000000e+00 -6.3869449890e-02 -1.9406713000e-01 +423 4.2300000000e+00 -6.1939528000e-02 -1.9188425280e-01 +424 4.2400000000e+00 -6.0031208040e-02 -1.8975732620e-01 +425 4.2500000000e+00 -5.8144037210e-02 -1.8766499860e-01 +426 4.2600000000e+00 -5.6277776300e-02 -1.8558591260e-01 +427 4.2700000000e+00 -5.4432399640e-02 -1.8349871850e-01 +428 4.2800000000e+00 -5.2608095090e-02 -1.8138206230e-01 +429 4.2900000000e+00 -5.0805264080e-02 -1.7921412530e-01 +430 4.3000000000e+00 -4.9024521580e-02 -1.7697218360e-01 +431 4.3100000000e+00 -4.7266676850e-02 -1.7463962540e-01 +432 4.3200000000e+00 -4.5532637180e-02 -1.7221329340e-01 +433 4.3300000000e+00 -4.3823311560e-02 -1.6969643540e-01 +434 4.3400000000e+00 -4.2139591520e-02 -1.6709130180e-01 +435 4.3500000000e+00 -4.0482351020e-02 -1.6439964880e-01 +436 4.3600000000e+00 -3.8852446520e-02 -1.6162322490e-01 +437 4.3700000000e+00 -3.7250716970e-02 -1.5876378180e-01 +438 4.3800000000e+00 -3.5677983800e-02 -1.5582307140e-01 +439 4.3900000000e+00 -3.4135050920e-02 -1.5280279030e-01 +440 4.4000000000e+00 -3.2622704710e-02 -1.4970451960e-01 +441 4.4100000000e+00 -3.1141711720e-02 -1.4653058420e-01 +442 4.4200000000e+00 -2.9692807030e-02 -1.4328494170e-01 +443 4.4300000000e+00 -2.8276682610e-02 -1.3997231400e-01 +444 4.4400000000e+00 -2.6893985010e-02 -1.3659730260e-01 +445 4.4500000000e+00 -2.5545315350e-02 -1.3316445100e-01 +446 4.4600000000e+00 -2.4231229320e-02 -1.2967830180e-01 +447 4.4700000000e+00 -2.2952237190e-02 -1.2614339590e-01 +448 4.4800000000e+00 -2.1708803810e-02 -1.2256427830e-01 +449 4.4900000000e+00 -2.0501348580e-02 -1.1894531750e-01 +450 4.5000000000e+00 -1.9330245510e-02 -1.1529053780e-01 +451 4.5100000000e+00 -1.8195816190e-02 -1.1160621010e-01 +452 4.5200000000e+00 -1.7098295100e-02 -1.0790348070e-01 +453 4.5300000000e+00 -1.6037794770e-02 -1.0419576570e-01 +454 4.5400000000e+00 -1.5014298890e-02 -1.0049612610e-01 +455 4.5500000000e+00 -1.4027662260e-02 -9.6817447880e-02 +456 4.5600000000e+00 -1.3077610840e-02 -9.3172619330e-02 +457 4.5700000000e+00 -1.2163741680e-02 -8.9574526510e-02 +458 4.5800000000e+00 -1.1285523010e-02 -8.6036054070e-02 +459 4.5900000000e+00 -1.0442294160e-02 -8.2570683340e-02 +460 4.6000000000e+00 -9.6332655980e-03 -7.9193083800e-02 +461 4.6100000000e+00 -8.8575419760e-03 -7.5910311180e-02 +462 4.6200000000e+00 -8.1142373740e-03 -7.2713282330e-02 +463 4.6300000000e+00 -7.4025905500e-03 -6.9585550720e-02 +464 4.6400000000e+00 -6.7219879870e-03 -6.6511783650e-02 +465 4.6500000000e+00 -6.0719638950e-03 -6.3477208480e-02 +466 4.6600000000e+00 -5.4522002110e-03 -6.0467053010e-02 +467 4.6700000000e+00 -4.8625265960e-03 -5.7466544920e-02 +468 4.6800000000e+00 -4.3029204390e-03 -5.4460911670e-02 +469 4.6900000000e+00 -3.7735068550e-03 -5.1434523580e-02 +470 4.7000000000e+00 -3.2745586850e-03 -4.8370043780e-02 +471 4.7100000000e+00 -2.8064617420e-03 -4.5261307720e-02 +472 4.7200000000e+00 -2.3695410370e-03 -4.2126515780e-02 +473 4.7300000000e+00 -1.9638870030e-03 -3.8995268370e-02 +474 4.7400000000e+00 -1.5893207430e-03 -3.5895375370e-02 +475 4.7500000000e+00 -1.2453940290e-03 -3.2853768170e-02 +476 4.7600000000e+00 -9.3138930210e-04 -2.9897377850e-02 +477 4.7700000000e+00 -6.4631967200e-04 -2.7053134890e-02 +478 4.7800000000e+00 -3.8892891730e-04 -2.4347968780e-02 +479 4.7900000000e+00 -1.5769148580e-04 -2.1809973910e-02 +480 4.8000000000e+00 4.9187505960e-05 -1.9469671160e-02 +481 4.8100000000e+00 2.3372925440e-04 -1.7342891530e-02 +482 4.8200000000e+00 3.9796617840e-04 -1.5415189150e-02 +483 4.8300000000e+00 5.4372682880e-04 -1.3658952380e-02 +484 4.8400000000e+00 6.7259287050e-04 -1.2048522610e-02 +485 4.8500000000e+00 7.8589908240e-04 -1.0559209690e-02 +486 4.8600000000e+00 8.8473335710e-04 -9.1663247630e-03 +487 4.8700000000e+00 9.6993670140e-04 -7.8451808230e-03 +488 4.8800000000e+00 1.0421032360e-03 -6.5710929150e-03 +489 4.8900000000e+00 1.1015801950e-03 -5.3185837070e-03 +490 4.9000000000e+00 1.1484679270e-03 -4.0606536610e-03 +491 4.9100000000e+00 1.1826519980e-03 -2.7805919490e-03 +492 4.9200000000e+00 1.2039636980e-03 -1.4840911740e-03 +493 4.9300000000e+00 1.2123405590e-03 -1.8744637850e-04 +494 4.9400000000e+00 1.2078584520e-03 1.0946955090e-03 +495 4.9500000000e+00 1.1907315900e-03 2.3485018540e-03 +496 4.9600000000e+00 1.1613125250e-03 3.5601402240e-03 +497 4.9700000000e+00 1.1200921520e-03 4.7157788300e-03 +498 4.9800000000e+00 1.0676997050e-03 5.8015868510e-03 +499 4.9900000000e+00 1.0049027610e-03 6.8031822230e-03 +500 5.0000000000e+00 9.3260723520e-04 7.7050078140e-03 +501 5.0100000000e+00 8.5183745480e-04 8.4983969340e-03 +502 5.0200000000e+00 7.6363650240e-04 9.1887805930e-03 +503 5.0300000000e+00 6.6896656300e-04 9.7875612980e-03 +504 5.0400000000e+00 5.6868899310e-04 1.0305252310e-02 +505 5.0500000000e+00 4.6356432080e-04 1.0751939230e-02 +506 5.0600000000e+00 3.5425224560e-04 1.1137708580e-02 +507 5.0700000000e+00 2.4131163850e-04 1.1472647570e-02 +508 5.0800000000e+00 1.2520054220e-04 1.1766843320e-02 +509 5.0900000000e+00 6.2761706890e-06 1.2030583530e-02 +510 5.1000000000e+00 -1.1520509050e-04 1.2274519120e-02 +511 5.1100000000e+00 -2.3908004220e-04 1.2506742270e-02 +512 5.1200000000e+00 -3.6524046290e-04 1.2730078350e-02 +513 5.1300000000e+00 -4.9359489830e-04 1.2944907750e-02 +514 5.1400000000e+00 -6.2406102030e-04 1.3151960710e-02 +515 5.1500000000e+00 -7.5656562640e-04 1.3352149800e-02 +516 5.1600000000e+00 -8.9104464010e-04 1.3546387640e-02 +517 5.1700000000e+00 -1.0274431110e-03 1.3735586810e-02 +518 5.1800000000e+00 -1.1657152140e-03 1.3920659690e-02 +519 5.1900000000e+00 -1.3058242490e-03 1.4102349940e-02 +520 5.2000000000e+00 -1.4477426450e-03 1.4281081480e-02 +521 5.2100000000e+00 -1.5914586660e-03 1.4459496790e-02 +522 5.2200000000e+00 -1.7370099740e-03 1.4644838790e-02 +523 5.2300000000e+00 -1.8845171920e-03 1.4846534220e-02 +524 5.2400000000e+00 -2.0341906130e-03 1.5073718280e-02 +525 5.2500000000e+00 -2.1863302000e-03 1.5335361050e-02 +526 5.2600000000e+00 -2.3413255880e-03 1.5640434670e-02 +527 5.2700000000e+00 -2.4996560810e-03 1.5997911230e-02 +528 5.2800000000e+00 -2.6618906560e-03 1.6416762160e-02 +529 5.2900000000e+00 -2.8286879610e-03 1.6906373970e-02 +530 5.3000000000e+00 -3.0007963120e-03 1.7477007110e-02 +531 5.3100000000e+00 -3.1790339990e-03 1.8133074970e-02 +532 5.3200000000e+00 -3.3641907710e-03 1.8865012170e-02 +533 5.3300000000e+00 -3.5569293410e-03 1.9656413040e-02 +534 5.3400000000e+00 -3.7577656750e-03 2.0492060870e-02 +535 5.3500000000e+00 -3.9670690000e-03 2.1357287210e-02 +536 5.3600000000e+00 -4.1850618000e-03 2.2237421170e-02 +537 5.3700000000e+00 -4.4118198130e-03 2.3117792040e-02 +538 5.3800000000e+00 -4.6472720400e-03 2.3983729020e-02 +539 5.3900000000e+00 -4.8912007360e-03 2.4820173120e-02 +540 5.4000000000e+00 -5.1432414150e-03 2.5611246230e-02 +541 5.4100000000e+00 -5.4028974590e-03 2.6345995690e-02 +542 5.4200000000e+00 -5.6696131800e-03 2.7023783330e-02 +543 5.4300000000e+00 -5.9428468820e-03 2.7648494840e-02 +544 5.4400000000e+00 -6.2220854650e-03 2.8223326690e-02 +545 5.4500000000e+00 -6.5068444350e-03 2.8751139070e-02 +546 5.4600000000e+00 -6.7966678950e-03 2.9234792020e-02 +547 5.4700000000e+00 -7.0911285520e-03 2.9677145900e-02 +548 5.4800000000e+00 -7.3898277130e-03 3.0081060730e-02 +549 5.4900000000e+00 -7.6923952860e-03 3.0449630790e-02 +550 5.5000000000e+00 -7.9984897810e-03 3.0786428800e-02 +551 5.5100000000e+00 -8.3077897170e-03 3.1092132900e-02 +552 5.5200000000e+00 -8.6199506760e-03 3.1361354280e-02 +553 5.5300000000e+00 -8.9345623430e-03 3.1586068180e-02 +554 5.5400000000e+00 -9.2511399250e-03 3.1758727190e-02 +555 5.5500000000e+00 -9.5691241460e-03 3.1872314690e-02 +556 5.5600000000e+00 -9.8878812460e-03 3.1879060490e-02 +557 5.5700000000e+00 -1.0206702980e-02 3.1879343290e-02 +558 5.5800000000e+00 -1.0524806640e-02 3.1775291070e-02 +559 5.5900000000e+00 -1.0841335000e-02 3.1575078260e-02 +560 5.6000000000e+00 -1.1155356390e-02 3.1277094940e-02 +561 5.6100000000e+00 -1.1465874190e-02 3.0876002420e-02 +562 5.6200000000e+00 -1.1771874720e-02 3.0373359010e-02 +563 5.6300000000e+00 -1.2072375040e-02 2.9774158060e-02 +564 5.6400000000e+00 -1.2366432510e-02 2.9082718780e-02 +565 5.6500000000e+00 -1.2653144820e-02 2.8303067980e-02 +566 5.6600000000e+00 -1.2931649940e-02 2.7439235100e-02 +567 5.6700000000e+00 -1.3201126190e-02 2.6495251650e-02 +568 5.6800000000e+00 -1.3460792170e-02 2.5475145970e-02 +569 5.6900000000e+00 -1.3709906810e-02 2.4382869130e-02 +570 5.7000000000e+00 -1.3947769340e-02 2.3222203640e-02 +571 5.7100000000e+00 -1.4173722750e-02 2.1998018300e-02 +572 5.7200000000e+00 -1.4387171000e-02 2.0717601730e-02 +573 5.7300000000e+00 -1.4587596210e-02 1.9389388150e-02 +574 5.7400000000e+00 -1.4774562110e-02 1.8021631230e-02 +575 5.7500000000e+00 -1.4947714070e-02 1.6622492240e-02 +576 5.7600000000e+00 -1.5106779050e-02 1.5200129840e-02 +577 5.7700000000e+00 -1.5251565630e-02 1.3762707810e-02 +578 5.7800000000e+00 -1.5381964020e-02 1.2318387210e-02 +579 5.7900000000e+00 -1.5497946030e-02 1.0875476430e-02 +580 5.8000000000e+00 -1.5599565090e-02 9.4425870750e-03 +581 5.8100000000e+00 -1.5686950370e-02 8.0264086870e-03 +582 5.8200000000e+00 -1.5760277400e-02 6.6295090340e-03 +583 5.8300000000e+00 -1.5819738700e-02 5.2525609880e-03 +584 5.8400000000e+00 -1.5865537890e-02 3.8965319600e-03 +585 5.8500000000e+00 -1.5897889720e-02 2.5625313690e-03 +586 5.8600000000e+00 -1.5917020020e-02 1.2516718340e-03 +587 5.8700000000e+00 -1.5923165770e-02 -3.4937058100e-05 +588 5.8800000000e+00 -1.5916575010e-02 -1.2961843800e-03 +589 5.8900000000e+00 -1.5897506940e-02 -2.5310939070e-03 +590 5.9000000000e+00 -1.5866231840e-02 -3.7389705170e-03 +591 5.9100000000e+00 -1.5823036470e-02 -4.9173578470e-03 +592 5.9200000000e+00 -1.5768250830e-02 -6.0600357120e-03 +593 5.9300000000e+00 -1.5702275000e-02 -7.1590688840e-03 +594 5.9400000000e+00 -1.5625584430e-02 -8.2067883000e-03 +595 5.9500000000e+00 -1.5538730000e-02 -9.1956535530e-03 +596 5.9600000000e+00 -1.5442337980e-02 -1.0118124370e-02 +597 5.9700000000e+00 -1.5337110070e-02 -1.0966662250e-02 +598 5.9800000000e+00 -1.5223823350e-02 -1.1733731860e-02 +599 5.9900000000e+00 -1.5103330310e-02 -1.2411346770e-02 +600 6.0000000000e+00 -1.4976558850e-02 -1.2990539800e-02 +601 6.0100000000e+00 -1.4844496760e-02 -1.3467852250e-02 +602 6.0200000000e+00 -1.4708114030e-02 -1.3850882370e-02 +603 6.0300000000e+00 -1.4568285260e-02 -1.4151686870e-02 +604 6.0400000000e+00 -1.4425774100e-02 -1.4381668920e-02 +605 6.0500000000e+00 -1.4281233220e-02 -1.4551925990e-02 +606 6.0600000000e+00 -1.4135204390e-02 -1.4673570400e-02 +607 6.0700000000e+00 -1.3988118420e-02 -1.4757756220e-02 +608 6.0800000000e+00 -1.3840295150e-02 -1.4815688990e-02 +609 6.0900000000e+00 -1.3691943500e-02 -1.4859029650e-02 +610 6.1000000000e+00 -1.3543161430e-02 -1.4899772950e-02 +611 6.1100000000e+00 -1.3393954760e-02 -1.4944650430e-02 +612 6.1200000000e+00 -1.3244331080e-02 -1.4987875210e-02 +613 6.1300000000e+00 -1.3094393730e-02 -1.4999195980e-02 +614 6.1400000000e+00 -1.2944360580e-02 -1.5000406620e-02 +615 6.1500000000e+00 -1.2794564020e-02 -1.4968741120e-02 +616 6.1600000000e+00 -1.2645450970e-02 -1.4878631960e-02 +617 6.1700000000e+00 -1.2497582900e-02 -1.4726360280e-02 +618 6.1800000000e+00 -1.2351635780e-02 -1.4500650680e-02 +619 6.1900000000e+00 -1.2208400130e-02 -1.4189602640e-02 +620 6.2000000000e+00 -1.2068780980e-02 -1.3780088450e-02 +621 6.2100000000e+00 -1.1933770350e-02 -1.3266656360e-02 +622 6.2200000000e+00 -1.1804309490e-02 -1.2663757970e-02 +623 6.2300000000e+00 -1.1681151160e-02 -1.1995648740e-02 +624 6.2400000000e+00 -1.1564832050e-02 -1.1284711830e-02 +625 6.2500000000e+00 -1.1455672780e-02 -1.0552530900e-02 +626 6.2600000000e+00 -1.1353777930e-02 -9.8206944580e-03 +627 6.2700000000e+00 -1.1259036020e-02 -9.1107917220e-03 +628 6.2800000000e+00 -1.1171119520e-02 -8.4444087170e-03 +629 6.2900000000e+00 -1.1089484820e-02 -7.8440382630e-03 +630 6.3000000000e+00 -1.1013372280e-02 -7.3343059900e-03 +631 6.3100000000e+00 -1.0941837570e-02 -6.9286062890e-03 +632 6.3200000000e+00 -1.0873908590e-02 -6.6177004520e-03 +633 6.3300000000e+00 -1.0808742380e-02 -6.3836149380e-03 +634 6.3400000000e+00 -1.0745656480e-02 -6.2096675710e-03 +635 6.3500000000e+00 -1.0684128980e-02 -6.0797276050e-03 +636 6.3600000000e+00 -1.0623798440e-02 -5.9776679450e-03 +637 6.3700000000e+00 -1.0564463980e-02 -5.8875005540e-03 +638 6.3800000000e+00 -1.0506085210e-02 -5.7934100960e-03 +639 6.3900000000e+00 -1.0448782260e-02 -5.6790958870e-03 +640 6.4000000000e+00 -1.0392835790e-02 -5.5272351870e-03 +641 6.4100000000e+00 -1.0338663800e-02 -5.3265489450e-03 +642 6.4200000000e+00 -1.0286705990e-02 -5.0824779890e-03 +643 6.4300000000e+00 -1.0237307970e-02 -4.8090647670e-03 +644 6.4400000000e+00 -1.0190698140e-02 -4.5186980020e-03 +645 6.4500000000e+00 -1.0146987700e-02 -4.2230772190e-03 +646 6.4600000000e+00 -1.0106170660e-02 -3.9339072730e-03 +647 6.4700000000e+00 -1.0068123810e-02 -3.6628907880e-03 +648 6.4800000000e+00 -1.0032606730e-02 -3.4217128560e-03 +649 6.4900000000e+00 -9.9992617940e-03 -3.2226936060e-03 +650 6.5000000000e+00 -9.9676141880e-03 -3.0800614930e-03 +651 6.5100000000e+00 -9.9370921530e-03 -3.0007974900e-03 +652 6.5200000000e+00 -9.9071283790e-03 -2.9895971810e-03 +653 6.5300000000e+00 -9.8772613860e-03 -2.9909390270e-03 +654 6.5400000000e+00 -9.8471557910e-03 -3.0244442110e-03 +655 6.5500000000e+00 -9.8166023160e-03 -3.0807584720e-03 +656 6.5600000000e+00 -9.7855177830e-03 -3.1389446580e-03 +657 6.5700000000e+00 -9.7539451160e-03 -3.1876831780e-03 +658 6.5800000000e+00 -9.7220533400e-03 -3.1902459520e-03 +659 6.5900000000e+00 -9.6901375810e-03 -3.1905666810e-03 +660 6.6000000000e+00 -9.6586190680e-03 -3.1317577790e-03 +661 6.6100000000e+00 -9.6280205840e-03 -3.0113946400e-03 +662 6.6200000000e+00 -9.5988437380e-03 -2.8430708940e-03 +663 6.6300000000e+00 -9.5714462370e-03 -2.6468063050e-03 +664 6.6400000000e+00 -9.5460173390e-03 -2.4401082740e-03 +665 6.6500000000e+00 -9.5225778510e-03 -2.2397114760e-03 +666 6.6600000000e+00 -9.5009801320e-03 -2.0623027660e-03 +667 6.6700000000e+00 -9.4809080910e-03 -1.9242058160e-03 +668 6.6800000000e+00 -9.4618771900e-03 -1.8756816070e-03 +669 6.6900000000e+00 -9.4432344390e-03 -1.8737538630e-03 +670 6.7000000000e+00 -9.4241584000e-03 -1.9296967320e-03 +671 6.7100000000e+00 -9.4036962210e-03 -2.1193480020e-03 +672 6.7200000000e+00 -9.3809488110e-03 -2.3946186600e-03 +673 6.7300000000e+00 -9.3552560140e-03 -2.7229160010e-03 +674 6.7400000000e+00 -9.3262336490e-03 -3.0756765770e-03 +675 6.7500000000e+00 -9.2937735010e-03 -3.4254765850e-03 +676 6.7600000000e+00 -9.2580433320e-03 -3.7449102950e-03 +677 6.7700000000e+00 -9.2194868700e-03 -4.0068658770e-03 +678 6.7800000000e+00 -9.1788238190e-03 -4.1695216600e-03 +679 6.7900000000e+00 -9.1370498500e-03 -4.1709417970e-03 +680 6.8000000000e+00 -9.0954366100e-03 -4.1531823070e-03 +681 6.8100000000e+00 -9.0554785850e-03 -3.9087191710e-03 +682 6.8200000000e+00 -9.0186274690e-03 -3.5228649830e-03 +683 6.8300000000e+00 -8.9860265190e-03 -3.0396673600e-03 +684 6.8400000000e+00 -8.9584574300e-03 -2.4966871920e-03 +685 6.8500000000e+00 -8.9363403360e-03 -1.9298633360e-03 +686 6.8600000000e+00 -8.9197338070e-03 -1.3752156630e-03 +687 6.8700000000e+00 -8.9083348510e-03 -8.6872626790e-04 +688 6.8800000000e+00 -8.9014789130e-03 -4.4613382030e-04 +689 6.8900000000e+00 -8.8981398760e-03 -1.4464164490e-04 +690 6.9000000000e+00 -8.8969300610e-03 -9.3306974460e-05 +691 6.9100000000e+00 -8.8961599030e-03 -9.4842573110e-05 +692 6.9200000000e+00 -8.8941363350e-03 -2.6951752300e-04 +693 6.9300000000e+00 -8.8894611720e-03 -6.0677709890e-04 +694 6.9400000000e+00 -8.8810907890e-03 -1.0295850060e-03 +695 6.9500000000e+00 -8.8683361180e-03 -1.5032386040e-03 +696 6.9600000000e+00 -8.8508626520e-03 -1.9925371240e-03 +697 6.9700000000e+00 -8.8286904430e-03 -2.4622017850e-03 +698 6.9800000000e+00 -8.8021941000e-03 -2.8770558440e-03 +699 6.9900000000e+00 -8.7721027940e-03 -3.2001665000e-03 +700 7.0000000000e+00 -8.7395002530e-03 -3.3628110830e-03 +701 7.0100000000e+00 -8.7057669680e-03 -3.3616587300e-03 +702 7.0200000000e+00 -8.6722912150e-03 -3.3328724970e-03 +703 7.0300000000e+00 -8.6401800780e-03 -3.1369921780e-03 +704 7.0400000000e+00 -8.6102016490e-03 -2.8836524560e-03 +705 7.0500000000e+00 -8.5827850310e-03 -2.6048254500e-03 +706 7.0600000000e+00 -8.5580203390e-03 -2.3338108210e-03 +707 7.0700000000e+00 -8.5356586960e-03 -2.1036368350e-03 +708 7.0800000000e+00 -8.5151122380e-03 -1.9811072220e-03 +709 7.0900000000e+00 -8.4954541080e-03 -1.9777398690e-03 +710 7.1000000000e+00 -8.4754184640e-03 -2.0225113290e-03 +711 7.1100000000e+00 -8.4534593770e-03 -2.2965828040e-03 +712 7.1200000000e+00 -8.4280453800e-03 -2.7212170120e-03 +713 7.1300000000e+00 -8.3979540000e-03 -3.2510514740e-03 +714 7.1400000000e+00 -8.3623306660e-03 -3.8476514650e-03 +715 7.1500000000e+00 -8.3206887140e-03 -4.4744244140e-03 +716 7.1600000000e+00 -8.2729093820e-03 -5.0946981770e-03 +717 7.1700000000e+00 -8.2192418120e-03 -5.6718145680e-03 +718 7.1800000000e+00 -8.1603030520e-03 -6.1692539840e-03 +719 7.1900000000e+00 -8.0970780500e-03 -6.5487676050e-03 +720 7.2000000000e+00 -8.0309196620e-03 -6.7272229100e-03 +721 7.2100000000e+00 -7.9634907270e-03 -6.7259642140e-03 +722 7.2200000000e+00 -7.8964744890e-03 -6.6789598430e-03 +723 7.2300000000e+00 -7.8312850050e-03 -6.4221789350e-03 +724 7.2400000000e+00 -7.7690092330e-03 -6.0751032250e-03 +725 7.2500000000e+00 -7.7104070320e-03 -5.6689224870e-03 +726 7.2600000000e+00 -7.6559111550e-03 -5.2359769820e-03 +727 7.2700000000e+00 -7.6056272590e-03 -4.8087903910e-03 +728 7.2800000000e+00 -7.5593338980e-03 -4.4198555860e-03 +729 7.2900000000e+00 -7.5164825260e-03 -4.1030087070e-03 +730 7.3000000000e+00 -7.4761974950e-03 -3.8973776310e-03 +731 7.3100000000e+00 -7.4373205220e-03 -3.8759720650e-03 +732 7.3200000000e+00 -7.3986330090e-03 -3.8773675230e-03 +733 7.3300000000e+00 -7.3590783700e-03 -4.0015934670e-03 +734 7.3400000000e+00 -7.3178064890e-03 -4.2169764230e-03 +735 7.3500000000e+00 -7.2741737280e-03 -4.4858423140e-03 +736 7.3600000000e+00 -7.2277429200e-03 -4.7879201620e-03 +737 7.3700000000e+00 -7.1782833720e-03 -5.1026918510e-03 +738 7.3800000000e+00 -7.1257708670e-03 -5.4095927810e-03 +739 7.3900000000e+00 -7.0703876590e-03 -5.6872718710e-03 +740 7.4000000000e+00 -7.0125224790e-03 -5.9122800580e-03 +741 7.4100000000e+00 -6.9527445490e-03 -6.0705847630e-03 +742 7.4200000000e+00 -6.8916736910e-03 -6.1675051450e-03 +743 7.4300000000e+00 -6.8298504240e-03 -6.2135136040e-03 +744 7.4400000000e+00 -6.7677099870e-03 -6.2133123600e-03 +745 7.4500000000e+00 -6.7055823390e-03 -6.2119432270e-03 +746 7.4600000000e+00 -6.6436921590e-03 -6.1750902160e-03 +747 7.4700000000e+00 -6.5821588440e-03 -6.1325376130e-03 +748 7.4800000000e+00 -6.5209965140e-03 -6.0933858940e-03 +749 7.4900000000e+00 -6.4601140040e-03 -6.0833932360e-03 +750 7.5000000000e+00 -6.3993148730e-03 -6.0828678280e-03 +751 7.5100000000e+00 -6.3383152770e-03 -6.1110319720e-03 +752 7.5200000000e+00 -6.2768333710e-03 -6.1744378110e-03 +753 7.5300000000e+00 -6.2146787090e-03 -6.2517322550e-03 +754 7.5400000000e+00 -6.1517701230e-03 -6.3316236530e-03 +755 7.5500000000e+00 -6.0881357210e-03 -6.4034456450e-03 +756 7.5600000000e+00 -6.0239128920e-03 -6.4556549940e-03 +757 7.5700000000e+00 -5.9593483000e-03 -6.4558690390e-03 +758 7.5800000000e+00 -5.8947978880e-03 -6.4544047390e-03 +759 7.5900000000e+00 -5.8307268780e-03 -6.3840366970e-03 +760 7.6000000000e+00 -5.7677097690e-03 -6.2482392170e-03 +761 7.6100000000e+00 -5.7064038390e-03 -6.0415350870e-03 +762 7.6200000000e+00 -5.6474166590e-03 -5.7781975640e-03 +763 7.6300000000e+00 -5.5911735990e-03 -5.4820877910e-03 +764 7.6400000000e+00 -5.5378913320e-03 -5.1747939830e-03 +765 7.6500000000e+00 -5.4875778360e-03 -4.8770962220e-03 +766 7.6600000000e+00 -5.4400323880e-03 -4.6097357670e-03 +767 7.6700000000e+00 -5.3948455730e-03 -4.3932287400e-03 +768 7.6800000000e+00 -5.3513992750e-03 -4.2592350550e-03 +769 7.6900000000e+00 -5.3088666840e-03 -4.2582276760e-03 +770 7.7000000000e+00 -5.2662122910e-03 -4.2715994810e-03 +771 7.7100000000e+00 -5.2222317010e-03 -4.4675543320e-03 +772 7.7200000000e+00 -5.1757506940e-03 -4.7782011870e-03 +773 7.7300000000e+00 -5.1258242750e-03 -5.1707250140e-03 +774 7.7400000000e+00 -5.0717764940e-03 -5.6171552670e-03 +775 7.7500000000e+00 -5.0132004380e-03 -6.0907404020e-03 +776 7.7600000000e+00 -4.9499582360e-03 -6.5646596010e-03 +777 7.7700000000e+00 -4.8821810580e-03 -7.0120917520e-03 +778 7.7800000000e+00 -4.8102691140e-03 -7.4062816260e-03 +779 7.7900000000e+00 -4.7348916560e-03 -7.7192866600e-03 +780 7.8000000000e+00 -4.6569869740e-03 -7.9185010720e-03 +781 7.8100000000e+00 -4.5777234760e-03 -7.9357116620e-03 +782 7.8200000000e+00 -4.4983050530e-03 -7.9345538390e-03 +783 7.8300000000e+00 -4.4197764540e-03 -7.8056778610e-03 +784 7.8400000000e+00 -4.3429843580e-03 -7.5886231250e-03 +785 7.8500000000e+00 -4.2685773750e-03 -7.3171269070e-03 +786 7.8600000000e+00 -4.1970060460e-03 -7.0106527050e-03 +787 7.8700000000e+00 -4.1285228410e-03 -6.6888898820e-03 +788 7.8800000000e+00 -4.0631821630e-03 -6.3715753420e-03 +789 7.8900000000e+00 -4.0008403430e-03 -6.0790957490e-03 +790 7.9000000000e+00 -3.9411556450e-03 -5.8334960980e-03 +791 7.9100000000e+00 -3.8836100890e-03 -5.6490249270e-03 +792 7.9200000000e+00 -3.8276185730e-03 -5.5238274960e-03 +793 7.9300000000e+00 -3.7726380060e-03 -5.4503718460e-03 +794 7.9400000000e+00 -3.7181891260e-03 -5.4368290110e-03 +795 7.9500000000e+00 -3.6638565070e-03 -5.4375412710e-03 +796 7.9600000000e+00 -3.6092885500e-03 -5.4693271350e-03 +797 7.9700000000e+00 -3.5541974930e-03 -5.5364281040e-03 +798 7.9800000000e+00 -3.4983594020e-03 -5.6225227740e-03 +799 7.9900000000e+00 -3.4416141800e-03 -5.7213422600e-03 +800 8.0000000000e+00 -3.3838655570e-03 -5.8264552150e-03 +801 8.0100000000e+00 -3.3250799920e-03 -5.9317600090e-03 +802 8.0200000000e+00 -3.2652811390e-03 -6.0319529100e-03 +803 8.0300000000e+00 -3.2045443190e-03 -6.1220872130e-03 +804 8.0400000000e+00 -3.1429954090e-03 -6.1971772310e-03 +805 8.0500000000e+00 -3.0808108470e-03 -6.2523344830e-03 +806 8.0600000000e+00 -3.0182176310e-03 -6.2681669500e-03 +807 8.0700000000e+00 -2.9554933170e-03 -6.2687770620e-03 +808 8.0800000000e+00 -2.8929660200e-03 -6.2432932110e-03 +809 8.0900000000e+00 -2.8310144160e-03 -6.1668903030e-03 +810 8.1000000000e+00 -2.7700677390e-03 -6.0438459020e-03 +811 8.1100000000e+00 -2.7105918050e-03 -5.8720071740e-03 +812 8.1200000000e+00 -2.6530191240e-03 -5.6595409670e-03 +813 8.1300000000e+00 -2.5976790150e-03 -5.4196416380e-03 +814 8.1400000000e+00 -2.5447836260e-03 -5.1644165190e-03 +815 8.1500000000e+00 -2.4944279380e-03 -4.9055584030e-03 +816 8.1600000000e+00 -2.4465897580e-03 -4.6547632950e-03 +817 8.1700000000e+00 -2.4011297280e-03 -4.4237188540e-03 +818 8.1800000000e+00 -2.3577913170e-03 -4.2240813640e-03 +819 8.1900000000e+00 -2.3162008250e-03 -4.0681406080e-03 +820 8.2000000000e+00 -2.2758673830e-03 -3.9706319740e-03 +821 8.2100000000e+00 -2.2362029790e-03 -3.9611717460e-03 +822 8.2200000000e+00 -2.1966225940e-03 -3.9620151530e-03 +823 8.2300000000e+00 -2.1566443350e-03 -4.0194821090e-03 +824 8.2400000000e+00 -2.1159094640e-03 -4.1138208480e-03 +825 8.2500000000e+00 -2.0741823980e-03 -4.2252451690e-03 +826 8.2600000000e+00 -2.0313507070e-03 -4.3416947870e-03 +827 8.2700000000e+00 -1.9874251180e-03 -4.4510024540e-03 +828 8.2800000000e+00 -1.9425395100e-03 -4.5411700940e-03 +829 8.2900000000e+00 -1.8969509160e-03 -4.5850896530e-03 +830 8.3000000000e+00 -1.8510395260e-03 -4.5858122980e-03 +831 8.3100000000e+00 -1.8052902620e-03 -4.5663005390e-03 +832 8.3200000000e+00 -1.7602006790e-03 -4.4744051230e-03 +833 8.3300000000e+00 -1.7161888630e-03 -4.3453380180e-03 +834 8.3400000000e+00 -1.6735750130e-03 -4.1893095180e-03 +835 8.3500000000e+00 -1.6325814350e-03 -4.0160059210e-03 +836 8.3600000000e+00 -1.5933325480e-03 -3.8351750510e-03 +837 8.3700000000e+00 -1.5558548830e-03 -3.6565797610e-03 +838 8.3800000000e+00 -1.5200770810e-03 -3.4899795860e-03 +839 8.3900000000e+00 -1.4858298910e-03 -3.3455567640e-03 +840 8.4000000000e+00 -1.4528461780e-03 -3.2346895450e-03 +841 8.4100000000e+00 -1.4207748020e-03 -3.1637014420e-03 +842 8.4200000000e+00 -1.3892500700e-03 -3.1291533650e-03 +843 8.4300000000e+00 -1.3579611770e-03 -3.1292408310e-03 +844 8.4400000000e+00 -1.3266660940e-03 -3.1298911790e-03 +845 8.4500000000e+00 -1.2951915690e-03 -3.1576610340e-03 +846 8.4600000000e+00 -1.2634331300e-03 -3.1917512150e-03 +847 8.4700000000e+00 -1.2313550790e-03 -3.2259651180e-03 +848 8.4800000000e+00 -1.1989904980e-03 -3.2540630400e-03 +849 8.4900000000e+00 -1.1664412430e-03 -3.2555693480e-03 +850 8.5000000000e+00 -1.1338779510e-03 -3.2557025210e-03 +851 8.5100000000e+00 -1.1015326060e-03 -3.2234865450e-03 +852 8.5200000000e+00 -1.0696614040e-03 -3.1630718910e-03 +853 8.5300000000e+00 -1.0385076140e-03 -3.0791159010e-03 +854 8.5400000000e+00 -1.0082941500e-03 -2.9739076870e-03 +855 8.5500000000e+00 -9.7922357050e-04 -2.8494714080e-03 +856 8.5600000000e+00 -9.5147808060e-04 -2.7078379130e-03 +857 8.5700000000e+00 -9.2521952960e-04 -2.5510405740e-03 +858 8.5800000000e+00 -9.0058941240e-04 -2.3811136250e-03 +859 8.5900000000e+00 -8.7770886890e-04 -2.2000297810e-03 +860 8.6000000000e+00 -8.5667868430e-04 -2.0096305180e-03 +861 8.6100000000e+00 -8.3757669380e-04 -1.8125777800e-03 +862 8.6200000000e+00 -8.2044480670e-04 -1.6133743580e-03 +863 8.6300000000e+00 -8.0527603090e-04 -1.4173768830e-03 +864 8.6400000000e+00 -7.9201187730e-04 -1.2297980360e-03 +865 8.6500000000e+00 -7.8054236030e-04 -1.0557824940e-03 +866 8.6600000000e+00 -7.7070599730e-04 -9.0047077190e-04 +867 8.6700000000e+00 -7.6228980900e-04 -7.6899201130e-04 +868 8.6800000000e+00 -7.5502931930e-04 -6.6643613270e-04 +869 8.6900000000e+00 -7.4860855550e-04 -5.9822957020e-04 +870 8.7000000000e+00 -7.4266004790e-04 -5.9102166820e-04 +871 8.7100000000e+00 -7.3677624910e-04 -5.9136220610e-04 +872 8.7200000000e+00 -7.3056662870e-04 -6.3841529490e-04 +873 8.7300000000e+00 -7.2371476810e-04 -7.1895190120e-04 +874 8.7400000000e+00 -7.1598977950e-04 -8.1806870680e-04 +875 8.7500000000e+00 -7.0724630570e-04 -9.2737467390e-04 +876 8.7600000000e+00 -6.9742452050e-04 -1.0383773450e-03 +877 8.7700000000e+00 -6.8655012820e-04 -1.1425742970e-03 +878 8.7800000000e+00 -6.7473436410e-04 -1.2315130470e-03 +879 8.7900000000e+00 -6.6217399400e-04 -1.2963584120e-03 +880 8.8000000000e+00 -6.4915131470e-04 -1.3094343440e-03 +881 8.8100000000e+00 -6.3601950570e-04 -1.3089678270e-03 +882 8.8200000000e+00 -6.2312938900e-04 -1.2757712740e-03 +883 8.8300000000e+00 -6.1075618940e-04 -1.2096983960e-03 +884 8.8400000000e+00 -5.9908488620e-04 -1.1299283140e-03 +885 8.8500000000e+00 -5.8821021300e-04 -1.0452584110e-03 +886 8.8600000000e+00 -5.7813665840e-04 -9.6460283190e-04 +887 8.8700000000e+00 -5.6877846530e-04 -8.9678568750e-04 +888 8.8800000000e+00 -5.5995963120e-04 -8.5822913660e-04 +889 8.8900000000e+00 -5.5141390820e-04 -8.5747478260e-04 +890 8.9000000000e+00 -5.4278480290e-04 -8.6716956740e-04 +891 8.9100000000e+00 -5.3364421720e-04 -9.4133837340e-04 +892 8.9200000000e+00 -5.2358565110e-04 -1.0544350220e-03 +893 8.9300000000e+00 -5.1231740570e-04 -1.1904098590e-03 +894 8.9400000000e+00 -4.9968122430e-04 -1.3354564220e-03 +895 8.9500000000e+00 -4.8565229150e-04 -1.4763473930e-03 +896 8.9600000000e+00 -4.7033923410e-04 -1.5999042110e-03 +897 8.9700000000e+00 -4.5398412050e-04 -1.6934097630e-03 +898 8.9800000000e+00 -4.3696246120e-04 -1.7112894550e-03 +899 8.9900000000e+00 -4.1978320830e-04 -1.7124335300e-03 +900 9.0000000000e+00 -4.0308875560e-04 -1.6449196520e-03 +901 9.0100000000e+00 -3.8762791010e-04 -1.4817040520e-03 +902 9.0200000000e+00 -3.7412074740e-04 -1.2491702780e-03 +903 9.0300000000e+00 -3.6312346700e-04 -9.6992461550e-04 +904 9.0400000000e+00 -3.5500136390e-04 -6.6380635360e-04 +905 9.0500000000e+00 -3.4992882860e-04 -3.4982061670e-04 +906 9.0600000000e+00 -3.4788934670e-04 -4.6993457500e-05 +907 9.0700000000e+00 -3.4867549920e-04 2.2568020250e-04 +908 9.0800000000e+00 -3.5188896250e-04 4.4935964540e-04 +909 9.0900000000e+00 -3.5694050820e-04 6.0452910960e-04 +910 9.1000000000e+00 -3.6305000340e-04 6.1763862860e-04 +911 9.1100000000e+00 -3.6927825380e-04 6.1715722710e-04 +912 9.1200000000e+00 -3.7468622130e-04 4.9717594620e-04 +913 9.1300000000e+00 -3.7849424120e-04 2.9714995560e-04 +914 9.1400000000e+00 -3.8011386570e-04 4.8341320950e-05 +915 9.1500000000e+00 -3.7914786360e-04 -2.3046620100e-04 +916 9.1600000000e+00 -3.7539022070e-04 -5.2026924870e-04 +917 9.1700000000e+00 -3.6882613980e-04 -8.0202351890e-04 +918 9.1800000000e+00 -3.5963204020e-04 -1.0567133440e-03 +919 9.1900000000e+00 -3.4817555830e-04 -1.2645602590e-03 +920 9.2000000000e+00 -3.3501554730e-04 -1.4029450680e-03 +921 9.2100000000e+00 -3.2087683960e-04 -1.4283913870e-03 +922 9.2200000000e+00 -3.0652406010e-04 -1.4272958700e-03 +923 9.2300000000e+00 -2.9263543830e-04 -1.3643256150e-03 +924 9.2400000000e+00 -2.7977757160e-04 -1.2322371450e-03 +925 9.2500000000e+00 -2.6840542450e-04 -1.0605904210e-03 +926 9.2600000000e+00 -2.5886232930e-04 -8.6031093940e-04 +927 9.2700000000e+00 -2.5137998560e-04 -6.4249036470e-04 +928 9.2800000000e+00 -2.4607846060e-04 -4.1825876870e-04 +929 9.2900000000e+00 -2.4296618900e-04 -1.9902305240e-04 +930 9.3000000000e+00 -2.4193997290e-04 3.1845693800e-06 +931 9.3100000000e+00 -2.4279467890e-04 1.7966093380e-04 +932 9.3200000000e+00 -2.4527172140e-04 3.2868016980e-04 +933 9.3300000000e+00 -2.4910754640e-04 4.5137591900e-04 +934 9.3400000000e+00 -2.5404332870e-04 5.4842279990e-04 +935 9.3500000000e+00 -2.5982497130e-04 6.2029030100e-04 +936 9.3600000000e+00 -2.6620310570e-04 6.6743896290e-04 +937 9.3700000000e+00 -2.7293309200e-04 6.8128886900e-04 +938 9.3800000000e+00 -2.7977501880e-04 6.8122989380e-04 +939 9.3900000000e+00 -2.8649370290e-04 6.6561682560e-04 +940 9.4000000000e+00 -2.9285868980e-04 6.1822347770e-04 +941 9.4100000000e+00 -2.9864964660e-04 5.4912675690e-04 +942 9.4200000000e+00 -3.0368332670e-04 4.6394228000e-04 +943 9.4300000000e+00 -3.0784053560e-04 3.7019047190e-04 +944 9.4400000000e+00 -3.1107152360e-04 2.7494326710e-04 +945 9.4500000000e+00 -3.1339598590e-04 1.8510907390e-04 +946 9.4600000000e+00 -3.1490306250e-04 1.0756448490e-04 +947 9.4700000000e+00 -3.1575133810e-04 4.8999593660e-05 +948 9.4800000000e+00 -3.1616884250e-04 3.3107920740e-05 +949 9.4900000000e+00 -3.1645305020e-04 3.2380561200e-05 +950 9.5000000000e+00 -3.1697088070e-04 6.3754272530e-05 +951 9.5100000000e+00 -3.1814184860e-04 1.5167878300e-04 +952 9.5200000000e+00 -3.2035381530e-04 2.7601805580e-04 +953 9.5300000000e+00 -3.2387874080e-04 4.2128484640e-04 +954 9.5400000000e+00 -3.2885583420e-04 5.7377933880e-04 +955 9.5500000000e+00 -3.3529155330e-04 7.2032706750e-04 +956 9.5600000000e+00 -3.4305960490e-04 8.4781313400e-04 +957 9.5700000000e+00 -3.5190094460e-04 9.4358916640e-04 +958 9.5800000000e+00 -3.6142377720e-04 9.6133332950e-04 +959 9.5900000000e+00 -3.7110355600e-04 9.6244725480e-04 +960 9.6000000000e+00 -3.8028298350e-04 8.9260370630e-04 +961 9.6100000000e+00 -3.8819947730e-04 7.2570100330e-04 +962 9.6200000000e+00 -3.9412250090e-04 4.8863488130e-04 +963 9.6300000000e+00 -3.9749089540e-04 2.0465082210e-04 +964 9.6400000000e+00 -3.9794034490e-04 -1.0580965950e-04 +965 9.6500000000e+00 -3.9530337710e-04 -4.2315129320e-04 +966 9.6600000000e+00 -3.8960936300e-04 -7.2775947590e-04 +967 9.6700000000e+00 -3.8108451720e-04 -1.0000584900e-03 +968 9.6800000000e+00 -3.7015189750e-04 -1.2206640990e-03 +969 9.6900000000e+00 -3.5743140510e-04 -1.3686784530e-03 +970 9.7000000000e+00 -3.4373978450e-04 -1.3687177910e-03 +971 9.7100000000e+00 -3.3005711180e-04 -1.3677771240e-03 +972 9.7200000000e+00 -3.1735923270e-04 -1.2175506400e-03 +973 9.7300000000e+00 -3.0645020200e-04 -9.9744243200e-04 +974 9.7400000000e+00 -2.9792877150e-04 -7.2818771020e-04 +975 9.7500000000e+00 -2.9218838950e-04 -4.3000627220e-04 +976 9.7600000000e+00 -2.8941720110e-04 -1.2331077010e-04 +977 9.7700000000e+00 -2.8959804820e-04 1.7145429420e-04 +978 9.7800000000e+00 -2.9250846960e-04 4.3389135570e-04 +979 9.7900000000e+00 -2.9772070050e-04 6.4262374950e-04 +980 9.8000000000e+00 -3.0460167320e-04 7.7223408700e-04 +981 9.8100000000e+00 -3.1234484370e-04 7.7669650150e-04 +982 9.8200000000e+00 -3.2012932700e-04 7.7621752470e-04 +983 9.8300000000e+00 -3.2727903260e-04 6.8055189370e-04 +984 9.8400000000e+00 -3.3329449150e-04 5.4117460460e-04 +985 9.8500000000e+00 -3.3785285590e-04 3.7873497620e-04 +986 9.8600000000e+00 -3.4080789960e-04 2.1056974260e-04 +987 9.8700000000e+00 -3.4219001780e-04 5.4129325750e-05 +988 9.8800000000e+00 -3.4220622720e-04 -7.3421138480e-05 +989 9.8900000000e+00 -3.4124016580e-04 -1.2932529480e-04 +990 9.9000000000e+00 -3.3985209320e-04 -1.3027960630e-04 +991 9.9100000000e+00 -3.3874868130e-04 -9.4889177100e-05 +992 9.9200000000e+00 -3.3863196930e-04 4.0847818400e-05 +993 9.9300000000e+00 -3.4004831890e-04 2.2224472680e-04 +994 9.9400000000e+00 -3.4335820470e-04 4.3012047260e-04 +995 9.9500000000e+00 -3.4873621490e-04 6.4610107190e-04 +996 9.9600000000e+00 -3.5617105070e-04 8.5173520200e-04 +997 9.9700000000e+00 -3.6546552680e-04 1.0286755720e-03 +998 9.9800000000e+00 -3.7623657080e-04 1.1593557180e-03 +999 9.9900000000e+00 -3.8791522390e-04 1.1761944840e-03 +1000 1.0000000000e+01 -3.9974664040e-04 1.1767838920e-03 +1001 1.0010000000e+01 -4.1082104180e-04 1.0677225170e-03 +1002 1.0020000000e+01 -4.2022926040e-04 8.5414149960e-04 +1003 1.0030000000e+01 -4.2721876140e-04 5.7407440180e-04 +1004 1.0040000000e+01 -4.3122515020e-04 2.4718443700e-04 +1005 1.0050000000e+01 -4.3187226610e-04 -1.0782601200e-04 +1006 1.0060000000e+01 -4.2897216000e-04 -4.7219506290e-04 +1007 1.0070000000e+01 -4.2252495590e-04 -8.2716579100e-04 +1008 1.0080000000e+01 -4.1271859740e-04 -1.1540259710e-03 +1009 1.0090000000e+01 -3.9992847830e-04 -1.4333717600e-03 +1010 1.0100000000e+01 -3.8471695790e-04 -1.6437078990e-03 +1011 1.0110000000e+01 -3.6780865340e-04 -1.7721885790e-03 +1012 1.0120000000e+01 -3.4996932360e-04 -1.8019117800e-03 +1013 1.0130000000e+01 -3.3188505560e-04 -1.8006379560e-03 +1014 1.0140000000e+01 -3.1413816540e-04 -1.7566778600e-03 +1015 1.0150000000e+01 -2.9720729950e-04 -1.6504364580e-03 +1016 1.0160000000e+01 -2.8146759970e-04 -1.5122390050e-03 +1017 1.0170000000e+01 -2.6719093180e-04 -1.3521402890e-03 +1018 1.0180000000e+01 -2.5454617650e-04 -1.1803480910e-03 +1019 1.0190000000e+01 -2.4359958460e-04 -1.0073204990e-03 +1020 1.0200000000e+01 -2.3431519470e-04 -8.4406428450e-04 +1021 1.0210000000e+01 -2.2656453160e-04 -6.9838951460e-04 +1022 1.0220000000e+01 -2.2017314520e-04 -5.7144880500e-04 +1023 1.0230000000e+01 -2.1496692380e-04 -4.6164139160e-04 +1024 1.0240000000e+01 -2.1078135050e-04 -3.6780651980e-04 +1025 1.0250000000e+01 -2.0746151260e-04 -2.8898365970e-04 +1026 1.0260000000e+01 -2.0486210460e-04 -2.2421250740e-04 +1027 1.0270000000e+01 -2.0284742580e-04 -1.7253368530e-04 +1028 1.0280000000e+01 -2.0129137260e-04 -1.3299015590e-04 +1029 1.0290000000e+01 -2.0007742360e-04 -1.0462481120e-04 +1030 1.0300000000e+01 -1.9909862130e-04 -8.6482093950e-05 +1031 1.0310000000e+01 -1.9825740620e-04 -8.0176145770e-05 +1032 1.0320000000e+01 -1.9746489060e-04 -8.0270475810e-05 +1033 1.0330000000e+01 -1.9664013180e-04 -8.4149519230e-05 +1034 1.0340000000e+01 -1.9570996480e-04 -9.8408753000e-05 +1035 1.0350000000e+01 -1.9460896870e-04 -1.1878674230e-04 +1036 1.0360000000e+01 -1.9327943030e-04 -1.4453939260e-04 +1037 1.0370000000e+01 -1.9167130140e-04 -1.7490855840e-04 +1038 1.0380000000e+01 -1.8974215350e-04 -2.0913698290e-04 +1039 1.0390000000e+01 -1.8745712570e-04 -2.4647791360e-04 +1040 1.0400000000e+01 -1.8478887050e-04 -2.8620364200e-04 +1041 1.0410000000e+01 -1.8171776410e-04 -3.2750670860e-04 +1042 1.0420000000e+01 -1.7823319480e-04 -3.6939422980e-04 +1043 1.0430000000e+01 -1.7433482900e-04 -4.1079442840e-04 +1044 1.0440000000e+01 -1.7003277440e-04 -4.5066219870e-04 +1045 1.0450000000e+01 -1.6534746400e-04 -4.8797153340e-04 +1046 1.0460000000e+01 -1.6030953380e-04 -5.2170945500e-04 +1047 1.0470000000e+01 -1.5495969400e-04 -5.5087748210e-04 +1048 1.0480000000e+01 -1.4934859350e-04 -5.7449468730e-04 +1049 1.0490000000e+01 -1.4353667910e-04 -5.9151095890e-04 +1050 1.0500000000e+01 -1.3759404780e-04 -5.9895751610e-04 +1051 1.0510000000e+01 -1.3159786030e-04 -5.9884024670e-04 +1052 1.0520000000e+01 -1.2562008510e-04 -5.9671537190e-04 +1053 1.0530000000e+01 -1.1971541890e-04 -5.8645497820e-04 +1054 1.0540000000e+01 -1.1391907460e-04 -5.7377073050e-04 +1055 1.0550000000e+01 -1.0824702940e-04 -5.6047034270e-04 +1056 1.0560000000e+01 -1.0269628380e-04 -5.4839149330e-04 +1057 1.0570000000e+01 -9.7245133280e-05 -5.3923980200e-04 +1058 1.0580000000e+01 -9.1853451120e-05 -5.3911449470e-04 +1059 1.0590000000e+01 -8.6462982460e-05 -5.3910199430e-04 +1060 1.0600000000e+01 -8.0997650220e-05 -5.5041729600e-04 +1061 1.0610000000e+01 -7.5368739520e-05 -5.7173059930e-04 +1062 1.0620000000e+01 -6.9499402950e-05 -5.9987988550e-04 +1063 1.0630000000e+01 -6.3348728690e-05 -6.3019444120e-04 +1064 1.0640000000e+01 -5.6916004900e-05 -6.5859860260e-04 +1065 1.0650000000e+01 -5.0240052900e-05 -6.8133908400e-04 +1066 1.0660000000e+01 -4.3398535910e-05 -6.8721567780e-04 +1067 1.0670000000e+01 -3.6507243520e-05 -6.8762860290e-04 +1068 1.0680000000e+01 -2.9719352220e-05 -6.7391683480e-04 +1069 1.0690000000e+01 -2.3224662110e-05 -6.3517303510e-04 +1070 1.0700000000e+01 -1.7248809950e-05 -5.7135297940e-04 +1071 1.0710000000e+01 -1.2043859570e-05 -4.8077252260e-04 +1072 1.0720000000e+01 -7.8448100750e-06 -3.6813962720e-04 +1073 1.0730000000e+01 -4.8270281820e-06 -2.4116727060e-04 +1074 1.0740000000e+01 -3.0987780870e-06 -1.0674709090e-04 +1075 1.0750000000e+01 -2.7024744570e-06 2.8614036460e-05 +1076 1.0760000000e+01 -3.6159753210e-06 1.5853729430e-04 +1077 1.0770000000e+01 -5.7539145360e-06 2.7678298170e-04 +1078 1.0780000000e+01 -8.9690733710e-06 3.7726806870e-04 +1079 1.0790000000e+01 -1.3053790830e-05 4.5374751230e-04 +1080 1.0800000000e+01 -1.7741412250e-05 4.9645783070e-04 +1081 1.0810000000e+01 -2.2717402080e-05 4.9635768930e-04 +1082 1.0820000000e+01 -2.7668550310e-05 4.9373434340e-04 +1083 1.0830000000e+01 -3.2330964780e-05 4.5092721080e-04 +1084 1.0840000000e+01 -3.6498647170e-05 3.9091840760e-04 +1085 1.0850000000e+01 -4.0022298200e-05 3.1893553480e-04 +1086 1.0860000000e+01 -4.2808089230e-05 2.4038641930e-04 +1087 1.0870000000e+01 -4.4816400650e-05 1.6059919060e-04 +1088 1.0880000000e+01 -4.6060527570e-05 8.4780110980e-05 +1089 1.0890000000e+01 -4.6605352970e-05 1.8223653080e-05 +1090 1.0900000000e+01 -4.6565988960e-05 -3.3314987920e-05 +1091 1.0910000000e+01 -4.6099238430e-05 -6.6873796480e-05 +1092 1.0920000000e+01 -4.5366824730e-05 -8.4916136160e-05 +1093 1.0930000000e+01 -4.4499679130e-05 -9.0355700370e-05 +1094 1.0940000000e+01 -4.3591609800e-05 -8.9952927120e-05 +1095 1.0950000000e+01 -4.2700237280e-05 -8.7651375340e-05 +1096 1.0960000000e+01 -4.1847951690e-05 -8.3360830850e-05 +1097 1.0970000000e+01 -4.1022891310e-05 -8.2903739490e-05 +1098 1.0980000000e+01 -4.0179942230e-05 -8.5063482370e-05 +1099 1.0990000000e+01 -3.9241758770e-05 -9.8313192120e-05 +1100 1.1000000000e+01 -3.8099804360e-05 -1.2447822810e-04 +1101 1.1010000000e+01 -3.6621345410e-05 -1.6534170470e-04 +1102 1.1020000000e+01 -3.4679816320e-05 -2.1818064580e-04 +1103 1.1030000000e+01 -3.2184148770e-05 -2.7819907000e-04 +1104 1.1040000000e+01 -2.9083598200e-05 -3.4125702240e-04 +1105 1.1050000000e+01 -2.5366519500e-05 -4.0351991940e-04 +1106 1.1060000000e+01 -2.1059118990e-05 -4.6127744400e-04 +1107 1.1070000000e+01 -1.6224183250e-05 -5.1095646380e-04 +1108 1.1080000000e+01 -1.0959784980e-05 -5.4915926570e-04 +1109 1.1090000000e+01 -5.3979664600e-06 -5.6732102600e-04 +1110 1.1100000000e+01 2.9659907510e-07 -5.6742631160e-04 +1111 1.1110000000e+01 5.9341452010e-06 -5.6066382740e-04 +1112 1.1120000000e+01 1.1331617930e-05 -5.2705013840e-04 +1113 1.1130000000e+01 1.6343217970e-05 -4.8102892890e-04 +1114 1.1140000000e+01 2.0865295550e-05 -4.2682936100e-04 +1115 1.1150000000e+01 2.4834928580e-05 -3.6840379250e-04 +1116 1.1160000000e+01 2.8228476910e-05 -3.0958860270e-04 +1117 1.1170000000e+01 3.1060112970e-05 -2.5407827860e-04 +1118 1.1180000000e+01 3.3380329340e-05 -2.0541192570e-04 +1119 1.1190000000e+01 3.5274423720e-05 -1.6718237570e-04 +1120 1.1200000000e+01 3.6860961690e-05 -1.4358272690e-04 +1121 1.1210000000e+01 3.8283995600e-05 -1.4050599770e-04 +1122 1.1220000000e+01 3.9680922010e-05 -1.4091331570e-04 +1123 1.1230000000e+01 4.1151837300e-05 -1.5145488130e-04 +1124 1.1240000000e+01 4.2754890750e-05 -1.6788298170e-04 +1125 1.1250000000e+01 4.4508020530e-05 -1.8405361040e-04 +1126 1.1260000000e+01 4.6390713930e-05 -1.9455426310e-04 +1127 1.1270000000e+01 4.8345791250e-05 -1.9485241340e-04 +1128 1.1280000000e+01 5.0281212820e-05 -1.9265493800e-04 +1129 1.1290000000e+01 5.2071908600e-05 -1.7208895670e-04 +1130 1.1300000000e+01 5.3561629730e-05 -1.3367792980e-04 +1131 1.1310000000e+01 5.4572080700e-05 -7.6096086180e-05 +1132 1.1320000000e+01 5.4940349260e-05 -3.4911970810e-06 +1133 1.1330000000e+01 5.4554256440e-05 7.7596661070e-05 +1134 1.1340000000e+01 5.3357134590e-05 1.6154909480e-04 +1135 1.1350000000e+01 5.1345125320e-05 2.4323900560e-04 +1136 1.1360000000e+01 4.8564445820e-05 3.1781175050e-04 +1137 1.1370000000e+01 4.5108624410e-05 3.8070237770e-04 +1138 1.1380000000e+01 4.1115706090e-05 4.2768998170e-04 +1139 1.1390000000e+01 3.6765429140e-05 4.4569996240e-04 +1140 1.1400000000e+01 3.2276373320e-05 4.4577483730e-04 +1141 1.1410000000e+01 2.7894657000e-05 4.3230431740e-04 +1142 1.1420000000e+01 2.3849973670e-05 3.8651116970e-04 +1143 1.1430000000e+01 2.0314535340e-05 3.2680232760e-04 +1144 1.1440000000e+01 1.7397851760e-05 2.5938783110e-04 +1145 1.1450000000e+01 1.5150232920e-05 1.8994220910e-04 +1146 1.1460000000e+01 1.3566325960e-05 1.2382271180e-04 +1147 1.1470000000e+01 1.2588685570e-05 6.6028107650e-05 +1148 1.1480000000e+01 1.2111376660e-05 2.1147970850e-05 +1149 1.1490000000e+01 1.1983608170e-05 -5.5445510610e-07 +1150 1.1500000000e+01 1.2013397080e-05 -6.3433927090e-07 +1151 1.1510000000e+01 1.1979618440e-05 6.9224805850e-06 +1152 1.1520000000e+01 1.1676213710e-05 4.4864949350e-05 +1153 1.1530000000e+01 1.0952841300e-05 9.4560562700e-05 +1154 1.1540000000e+01 9.7194851630e-06 1.5011734680e-04 +1155 1.1550000000e+01 7.9423493170e-06 2.0620127250e-04 +1156 1.1560000000e+01 5.6397197640e-06 2.5785045690e-04 +1157 1.1570000000e+01 2.8777951330e-06 3.0053260610e-04 +1158 1.1580000000e+01 -2.3351266940e-07 3.3028724980e-04 +1159 1.1590000000e+01 -3.5448065280e-06 3.3191037270e-04 +1160 1.1600000000e+01 -6.8714595930e-06 3.3193028550e-04 +1161 1.1610000000e+01 -1.0004797940e-05 3.0304498820e-04 +1162 1.1620000000e+01 -1.2749539600e-05 2.5408763700e-04 +1163 1.1630000000e+01 -1.4957470800e-05 1.9293355440e-04 +1164 1.1640000000e+01 -1.6530760420e-05 1.2458386860e-04 +1165 1.1650000000e+01 -1.7418004970e-05 5.3446519620e-05 +1166 1.1660000000e+01 -1.7610248450e-05 -1.6448088780e-05 +1167 1.1670000000e+01 -1.7136978150e-05 -8.1464308840e-05 +1168 1.1680000000e+01 -1.6062097780e-05 -1.3836894190e-04 +1169 1.1690000000e+01 -1.4479879090e-05 -1.8421787100e-04 +1170 1.1700000000e+01 -1.2510893210e-05 -2.1616290120e-04 +1171 1.1710000000e+01 -1.0294430290e-05 -2.3233687030e-04 +1172 1.1720000000e+01 -7.9678780230e-06 -2.3227402260e-04 +1173 1.1730000000e+01 -5.6486954130e-06 -2.3150892740e-04 +1174 1.1740000000e+01 -3.4322545090e-06 -2.1621802220e-04 +1175 1.1750000000e+01 -1.3934204810e-06 -1.9466108350e-04 +1176 1.1760000000e+01 4.1185956270e-07 -1.6850313820e-04 +1177 1.1770000000e+01 1.9449594820e-06 -1.3936779990e-04 +1178 1.1780000000e+01 3.1829692270e-06 -1.0873702930e-04 +1179 1.1790000000e+01 4.1170826780e-06 -7.7937096740e-05 +1180 1.1800000000e+01 4.7509787070e-06 -4.8134899120e-05 +1181 1.1810000000e+01 5.0991788260e-06 -2.0329557190e-05 +1182 1.1820000000e+01 5.1853377300e-06 4.6534024350e-06 +1183 1.1830000000e+01 5.0405482780e-06 2.6153287390e-05 +1184 1.1840000000e+01 4.7017245850e-06 4.3667703640e-05 +1185 1.1850000000e+01 4.2099998780e-06 5.6852853570e-05 +1186 1.1860000000e+01 3.6091206690e-06 6.5520030940e-05 +1187 1.1870000000e+01 2.9438377600e-06 6.8044387790e-05 +1188 1.1880000000e+01 2.2582945630e-06 6.8005776470e-05 +1189 1.1890000000e+01 1.5944132410e-06 6.5247449720e-05 +1190 1.1900000000e+01 9.9027914890e-07 5.7253374050e-05 +1191 1.1910000000e+01 4.7794482020e-07 4.6374107540e-05 +1192 1.1920000000e+01 7.9430367210e-08 3.3872879470e-05 +1193 1.1930000000e+01 -1.9586145530e-07 2.1091406450e-05 +1194 1.1940000000e+01 -3.5038203430e-07 9.1537875640e-06 +1195 1.1950000000e+01 -3.9696232700e-07 -9.8173844310e-07 +1196 1.1960000000e+01 -3.5733509120e-07 -8.5097413050e-06 +1197 1.1970000000e+01 -2.6065437280e-07 -1.1346751290e-05 +1198 1.1980000000e+01 -1.4201270800e-07 -1.1393547340e-05 +1199 1.1990000000e+01 -4.0956496040e-08 -8.7451546660e-06 +1200 1.2000000000e+01 0.0000000000e+00 -1.0906638080e-06 diff --git a/examples/PACKAGES/pair_sw_3b_table/table_CG_CG_CG.txt b/examples/PACKAGES/pair_sw_3b_table/table_CG_CG_CG.txt new file mode 100644 index 0000000000..d6d1c3e71e --- /dev/null +++ b/examples/PACKAGES/pair_sw_3b_table/table_CG_CG_CG.txt @@ -0,0 +1,1004 @@ +VOTCA +N 1001 + +1 0.00000e+00 -6.5399880e+01 -1.4141539e+00 +2 1.80000e-01 -6.5145332e+01 -1.4141539e+00 +3 3.60000e-01 -6.4890785e+01 -1.4141539e+00 +4 5.40000e-01 -6.4636237e+01 -1.4141539e+00 +5 7.20000e-01 -6.4381689e+01 -1.4141539e+00 +6 9.00000e-01 -6.4127142e+01 -1.4141539e+00 +7 1.08000e+00 -6.3872594e+01 -1.4141539e+00 +8 1.26000e+00 -6.3618046e+01 -1.4141539e+00 +9 1.44000e+00 -6.3363498e+01 -1.4141539e+00 +10 1.62000e+00 -6.3108951e+01 -1.4141539e+00 +11 1.80000e+00 -6.2854403e+01 -1.4141539e+00 +12 1.98000e+00 -6.2599855e+01 -1.4141539e+00 +13 2.16000e+00 -6.2345308e+01 -1.4141539e+00 +14 2.34000e+00 -6.2090760e+01 -1.4141539e+00 +15 2.52000e+00 -6.1836212e+01 -1.4141539e+00 +16 2.70000e+00 -6.1581664e+01 -1.4141539e+00 +17 2.88000e+00 -6.1327117e+01 -1.4141539e+00 +18 3.06000e+00 -6.1072569e+01 -1.4141539e+00 +19 3.24000e+00 -6.0818021e+01 -1.4141539e+00 +20 3.42000e+00 -6.0563474e+01 -1.4141539e+00 +21 3.60000e+00 -6.0308926e+01 -1.4141539e+00 +22 3.78000e+00 -6.0054378e+01 -1.4141539e+00 +23 3.96000e+00 -5.9799831e+01 -1.4141539e+00 +24 4.14000e+00 -5.9545283e+01 -1.4141539e+00 +25 4.32000e+00 -5.9290735e+01 -1.4141539e+00 +26 4.50000e+00 -5.9036187e+01 -1.4141539e+00 +27 4.68000e+00 -5.8781640e+01 -1.4141539e+00 +28 4.86000e+00 -5.8527092e+01 -1.4141539e+00 +29 5.04000e+00 -5.8272544e+01 -1.4141539e+00 +30 5.22000e+00 -5.8017997e+01 -1.4141539e+00 +31 5.40000e+00 -5.7763449e+01 -1.4141539e+00 +32 5.58000e+00 -5.7508901e+01 -1.4141539e+00 +33 5.76000e+00 -5.7254354e+01 -1.4141539e+00 +34 5.94000e+00 -5.6999806e+01 -1.4141539e+00 +35 6.12000e+00 -5.6745258e+01 -1.4141539e+00 +36 6.30000e+00 -5.6490710e+01 -1.4141539e+00 +37 6.48000e+00 -5.6236163e+01 -1.4141539e+00 +38 6.66000e+00 -5.5981615e+01 -1.4141539e+00 +39 6.84000e+00 -5.5727067e+01 -1.4141539e+00 +40 7.02000e+00 -5.5472520e+01 -1.4141539e+00 +41 7.20000e+00 -5.5217972e+01 -1.4141539e+00 +42 7.38000e+00 -5.4963424e+01 -1.4141539e+00 +43 7.56000e+00 -5.4708876e+01 -1.4141539e+00 +44 7.74000e+00 -5.4454329e+01 -1.4141539e+00 +45 7.92000e+00 -5.4199781e+01 -1.4141539e+00 +46 8.10000e+00 -5.3945233e+01 -1.4141539e+00 +47 8.28000e+00 -5.3690686e+01 -1.4141539e+00 +48 8.46000e+00 -5.3436138e+01 -1.4141539e+00 +49 8.64000e+00 -5.3181590e+01 -1.4141539e+00 +50 8.82000e+00 -5.2927043e+01 -1.4141539e+00 +51 9.00000e+00 -5.2672495e+01 -1.4141539e+00 +52 9.18000e+00 -5.2417947e+01 -1.4141539e+00 +53 9.36000e+00 -5.2163399e+01 -1.4141539e+00 +54 9.54000e+00 -5.1908852e+01 -1.4141539e+00 +55 9.72000e+00 -5.1654304e+01 -1.4141539e+00 +56 9.90000e+00 -5.1399756e+01 -1.4141539e+00 +57 1.00800e+01 -5.1145209e+01 -1.4141539e+00 +58 1.02600e+01 -5.0890661e+01 -1.4141539e+00 +59 1.04400e+01 -5.0636113e+01 -1.4141539e+00 +60 1.06200e+01 -5.0381565e+01 -1.4141539e+00 +61 1.08000e+01 -5.0127018e+01 -1.4141539e+00 +62 1.09800e+01 -4.9872470e+01 -1.4141539e+00 +63 1.11600e+01 -4.9617922e+01 -1.4141539e+00 +64 1.13400e+01 -4.9363375e+01 -1.4141539e+00 +65 1.15200e+01 -4.9108827e+01 -1.4141539e+00 +66 1.17000e+01 -4.8854279e+01 -1.4141539e+00 +67 1.18800e+01 -4.8599732e+01 -1.4141539e+00 +68 1.20600e+01 -4.8345184e+01 -1.4141539e+00 +69 1.22400e+01 -4.8090636e+01 -1.4141539e+00 +70 1.24200e+01 -4.7836088e+01 -1.4141539e+00 +71 1.26000e+01 -4.7581541e+01 -1.4141539e+00 +72 1.27800e+01 -4.7326993e+01 -1.4141539e+00 +73 1.29600e+01 -4.7072445e+01 -1.4141539e+00 +74 1.31400e+01 -4.6817898e+01 -1.4141539e+00 +75 1.33200e+01 -4.6563350e+01 -1.4141539e+00 +76 1.35000e+01 -4.6308802e+01 -1.4141539e+00 +77 1.36800e+01 -4.6054255e+01 -1.4141539e+00 +78 1.38600e+01 -4.5799707e+01 -1.4141539e+00 +79 1.40400e+01 -4.5545159e+01 -1.4141539e+00 +80 1.42200e+01 -4.5290611e+01 -1.4141539e+00 +81 1.44000e+01 -4.5036064e+01 -1.4141539e+00 +82 1.45800e+01 -4.4781516e+01 -1.4141539e+00 +83 1.47600e+01 -4.4526968e+01 -1.4141539e+00 +84 1.49400e+01 -4.4272421e+01 -1.4141539e+00 +85 1.51200e+01 -4.4017873e+01 -1.4141539e+00 +86 1.53000e+01 -4.3763325e+01 -1.4141539e+00 +87 1.54800e+01 -4.3508777e+01 -1.4141539e+00 +88 1.56600e+01 -4.3254230e+01 -1.4141539e+00 +89 1.58400e+01 -4.2999682e+01 -1.4141539e+00 +90 1.60200e+01 -4.2745134e+01 -1.4141539e+00 +91 1.62000e+01 -4.2490587e+01 -1.4141539e+00 +92 1.63800e+01 -4.2236039e+01 -1.4141539e+00 +93 1.65600e+01 -4.1981491e+01 -1.4141539e+00 +94 1.67400e+01 -4.1726944e+01 -1.4141539e+00 +95 1.69200e+01 -4.1472396e+01 -1.4141539e+00 +96 1.71000e+01 -4.1217848e+01 -1.4141539e+00 +97 1.72800e+01 -4.0963300e+01 -1.4141539e+00 +98 1.74600e+01 -4.0708753e+01 -1.4141539e+00 +99 1.76400e+01 -4.0454205e+01 -1.4141539e+00 +100 1.78200e+01 -4.0199657e+01 -1.4141539e+00 +101 1.80000e+01 -3.9945110e+01 -1.4141539e+00 +102 1.81800e+01 -3.9690562e+01 -1.4141539e+00 +103 1.83600e+01 -3.9436014e+01 -1.4141539e+00 +104 1.85400e+01 -3.9181467e+01 -1.4141539e+00 +105 1.87200e+01 -3.8926919e+01 -1.4141539e+00 +106 1.89000e+01 -3.8672371e+01 -1.4141539e+00 +107 1.90800e+01 -3.8417823e+01 -1.4141539e+00 +108 1.92600e+01 -3.8163276e+01 -1.4141539e+00 +109 1.94400e+01 -3.7908728e+01 -1.4141539e+00 +110 1.96200e+01 -3.7654180e+01 -1.4141539e+00 +111 1.98000e+01 -3.7399633e+01 -1.4141539e+00 +112 1.99800e+01 -3.7145085e+01 -1.4141539e+00 +113 2.01600e+01 -3.6890537e+01 -1.4141539e+00 +114 2.03400e+01 -3.6635989e+01 -1.4141539e+00 +115 2.05200e+01 -3.6381442e+01 -1.4141539e+00 +116 2.07000e+01 -3.6126894e+01 -1.4141539e+00 +117 2.08800e+01 -3.5872346e+01 -1.4141539e+00 +118 2.10600e+01 -3.5617799e+01 -1.4141539e+00 +119 2.12400e+01 -3.5363251e+01 -1.4141539e+00 +120 2.14200e+01 -3.5108703e+01 -1.4141539e+00 +121 2.16000e+01 -3.4854156e+01 -1.4141539e+00 +122 2.17800e+01 -3.4599608e+01 -1.4141539e+00 +123 2.19600e+01 -3.4345060e+01 -1.4141539e+00 +124 2.21400e+01 -3.4090512e+01 -1.4141539e+00 +125 2.23200e+01 -3.3835965e+01 -1.4141539e+00 +126 2.25000e+01 -3.3581417e+01 -1.4141539e+00 +127 2.26800e+01 -3.3326869e+01 -1.4141539e+00 +128 2.28600e+01 -3.3072322e+01 -1.4141539e+00 +129 2.30400e+01 -3.2817774e+01 -1.4141539e+00 +130 2.32200e+01 -3.2563226e+01 -1.4141539e+00 +131 2.34000e+01 -3.2308679e+01 -1.4141539e+00 +132 2.35800e+01 -3.2054131e+01 -1.4141539e+00 +133 2.37600e+01 -3.1799583e+01 -1.4141539e+00 +134 2.39400e+01 -3.1545035e+01 -1.4141539e+00 +135 2.41200e+01 -3.1290488e+01 -1.4141539e+00 +136 2.43000e+01 -3.1035940e+01 -1.4141539e+00 +137 2.44800e+01 -3.0781392e+01 -1.4141539e+00 +138 2.46600e+01 -3.0526845e+01 -1.4141539e+00 +139 2.48400e+01 -3.0272297e+01 -1.4141539e+00 +140 2.50200e+01 -3.0017749e+01 -1.4141539e+00 +141 2.52000e+01 -2.9763201e+01 -1.4141539e+00 +142 2.53800e+01 -2.9508654e+01 -1.4141539e+00 +143 2.55600e+01 -2.9254106e+01 -1.4141539e+00 +144 2.57400e+01 -2.8999558e+01 -1.4141539e+00 +145 2.59200e+01 -2.8745011e+01 -1.4141539e+00 +146 2.61000e+01 -2.8490463e+01 -1.4141539e+00 +147 2.62800e+01 -2.8235915e+01 -1.4141539e+00 +148 2.64600e+01 -2.7981368e+01 -1.4141539e+00 +149 2.66400e+01 -2.7726820e+01 -1.4141539e+00 +150 2.68200e+01 -2.7472272e+01 -1.4141539e+00 +151 2.70000e+01 -2.7217724e+01 -1.4141539e+00 +152 2.71800e+01 -2.6963177e+01 -1.4141539e+00 +153 2.73600e+01 -2.6708629e+01 -1.4141539e+00 +154 2.75400e+01 -2.6454081e+01 -1.4141539e+00 +155 2.77200e+01 -2.6199534e+01 -1.4141539e+00 +156 2.79000e+01 -2.5944986e+01 -1.4141539e+00 +157 2.80800e+01 -2.5690438e+01 -1.4141539e+00 +158 2.82600e+01 -2.5435890e+01 -1.4141539e+00 +159 2.84400e+01 -2.5181343e+01 -1.4141539e+00 +160 2.86200e+01 -2.4926795e+01 -1.4141539e+00 +161 2.88000e+01 -2.4672247e+01 -1.4141539e+00 +162 2.89800e+01 -2.4417700e+01 -1.4141539e+00 +163 2.91600e+01 -2.4163152e+01 -1.4141539e+00 +164 2.93400e+01 -2.3908604e+01 -1.4141539e+00 +165 2.95200e+01 -2.3654057e+01 -1.4141539e+00 +166 2.97000e+01 -2.3399509e+01 -1.4141539e+00 +167 2.98800e+01 -2.3144961e+01 -1.4141539e+00 +168 3.00600e+01 -2.2890413e+01 -1.4141539e+00 +169 3.02400e+01 -2.2635866e+01 -1.4141539e+00 +170 3.04200e+01 -2.2381318e+01 -1.4141539e+00 +171 3.06000e+01 -2.2126770e+01 -1.4141539e+00 +172 3.07800e+01 -2.1872223e+01 -1.4141539e+00 +173 3.09600e+01 -2.1617675e+01 -1.4141539e+00 +174 3.11400e+01 -2.1363127e+01 -1.4141539e+00 +175 3.13200e+01 -2.1108580e+01 -1.4141539e+00 +176 3.15000e+01 -2.0854032e+01 -1.4141539e+00 +177 3.16800e+01 -2.0599484e+01 -1.4141539e+00 +178 3.18600e+01 -2.0344936e+01 -1.4141539e+00 +179 3.20400e+01 -2.0090389e+01 -1.4141539e+00 +180 3.22200e+01 -1.9835841e+01 -1.4141539e+00 +181 3.24000e+01 -1.9581293e+01 -1.4141539e+00 +182 3.25800e+01 -1.9326746e+01 -1.4141539e+00 +183 3.27600e+01 -1.9072198e+01 -1.4141539e+00 +184 3.29400e+01 -1.8817650e+01 -1.4141539e+00 +185 3.31200e+01 -1.8563102e+01 -1.4141539e+00 +186 3.33000e+01 -1.8308555e+01 -1.4141539e+00 +187 3.34800e+01 -1.8054007e+01 -1.4141539e+00 +188 3.36600e+01 -1.7799459e+01 -1.4141539e+00 +189 3.38400e+01 -1.7544912e+01 -1.4141539e+00 +190 3.40200e+01 -1.7290364e+01 -1.4141539e+00 +191 3.42000e+01 -1.7035816e+01 -1.4141539e+00 +192 3.43800e+01 -1.6781269e+01 -1.4141539e+00 +193 3.45600e+01 -1.6526721e+01 -1.4141539e+00 +194 3.47400e+01 -1.6272173e+01 -1.4141539e+00 +195 3.49200e+01 -1.6017625e+01 -1.4141539e+00 +196 3.51000e+01 -1.5763078e+01 -1.4141539e+00 +197 3.52800e+01 -1.5508530e+01 -1.4141539e+00 +198 3.54600e+01 -1.5253982e+01 -1.4141539e+00 +199 3.56400e+01 -1.4999435e+01 -1.4141539e+00 +200 3.58200e+01 -1.4744887e+01 -1.4141539e+00 +201 3.60000e+01 -1.4490339e+01 -1.4141539e+00 +202 3.61800e+01 -1.4235792e+01 -1.4141539e+00 +203 3.63600e+01 -1.3981244e+01 -1.4141539e+00 +204 3.65400e+01 -1.3726696e+01 -1.4141539e+00 +205 3.67200e+01 -1.3472148e+01 -1.4141539e+00 +206 3.69000e+01 -1.3217601e+01 -1.4141539e+00 +207 3.70800e+01 -1.2963053e+01 -1.4141539e+00 +208 3.72600e+01 -1.2708505e+01 -1.4141539e+00 +209 3.74400e+01 -1.2453958e+01 -1.4141539e+00 +210 3.76200e+01 -1.2199410e+01 -1.4141539e+00 +211 3.78000e+01 -1.1944862e+01 -1.4141539e+00 +212 3.79800e+01 -1.1690314e+01 -1.4141539e+00 +213 3.81600e+01 -1.1435767e+01 -1.4141539e+00 +214 3.83400e+01 -1.1181219e+01 -1.4141539e+00 +215 3.85200e+01 -1.0926671e+01 -1.4141539e+00 +216 3.87000e+01 -1.0672124e+01 -1.4141539e+00 +217 3.88800e+01 -1.0417576e+01 -1.4141539e+00 +218 3.90600e+01 -1.0163028e+01 -1.4141539e+00 +219 3.92400e+01 -9.9084806e+00 -1.4141539e+00 +220 3.94200e+01 -9.6539329e+00 -1.4141539e+00 +221 3.96000e+01 -9.3993852e+00 -1.4141539e+00 +222 3.97800e+01 -9.1448374e+00 -1.4141539e+00 +223 3.99600e+01 -8.8902897e+00 -1.4141539e+00 +224 4.01400e+01 -8.6357420e+00 -1.4141539e+00 +225 4.03200e+01 -8.3811943e+00 -1.4141539e+00 +226 4.05000e+01 -8.1266466e+00 -1.4141539e+00 +227 4.06800e+01 -7.8720989e+00 -1.4141539e+00 +228 4.08600e+01 -7.6175512e+00 -1.4141539e+00 +229 4.10400e+01 -7.3630035e+00 -1.4141539e+00 +230 4.12200e+01 -7.1084558e+00 -1.4141539e+00 +231 4.14000e+01 -6.8539081e+00 -1.4141539e+00 +232 4.15800e+01 -6.5993604e+00 -1.4141539e+00 +233 4.17600e+01 -6.3451123e+00 -1.4116569e+00 +234 4.19400e+01 -6.0913137e+00 -1.4087437e+00 +235 4.21200e+01 -5.8381144e+00 -1.4049982e+00 +236 4.23000e+01 -5.5856642e+00 -1.4004204e+00 +237 4.24800e+01 -5.3341129e+00 -1.3950102e+00 +238 4.26600e+01 -5.0836104e+00 -1.3887676e+00 +239 4.28400e+01 -4.8343064e+00 -1.3816928e+00 +240 4.30200e+01 -4.5863508e+00 -1.3737856e+00 +241 4.32000e+01 -4.3398934e+00 -1.3650460e+00 +242 4.33800e+01 -4.0950840e+00 -1.3554741e+00 +243 4.35600e+01 -3.8520725e+00 -1.3450699e+00 +244 4.37400e+01 -3.6110087e+00 -1.3338334e+00 +245 4.39200e+01 -3.3720423e+00 -1.3217645e+00 +246 4.41000e+01 -3.1353233e+00 -1.3088632e+00 +247 4.42800e+01 -2.9010014e+00 -1.2951297e+00 +248 4.44600e+01 -2.6692264e+00 -1.2805638e+00 +249 4.46400e+01 -2.4401483e+00 -1.2651655e+00 +250 4.48200e+01 -2.2139167e+00 -1.2489349e+00 +251 4.50000e+01 -1.9906815e+00 -1.2318720e+00 +252 4.51800e+01 -1.7705926e+00 -1.2139768e+00 +253 4.53600e+01 -1.5537997e+00 -1.1952492e+00 +254 4.55400e+01 -1.3404527e+00 -1.1756892e+00 +255 4.57200e+01 -1.1307014e+00 -1.1552970e+00 +256 4.59000e+01 -9.2469562e-01 -1.1340723e+00 +257 4.60800e+01 -7.2258518e-01 -1.1120154e+00 +258 4.62600e+01 -5.2451990e-01 -1.0891261e+00 +259 4.64400e+01 -3.3064960e-01 -1.0654045e+00 +260 4.66200e+01 -1.4112410e-01 -1.0408503e+00 +261 4.68000e+01 4.3906773e-02 -1.0153760e+00 +262 4.69800e+01 2.2429340e-01 -9.8902709e-01 +263 4.71600e+01 3.9995134e-01 -9.6270864e-01 +264 4.73400e+01 5.7095483e-01 -9.3709040e-01 +265 4.75200e+01 7.3740183e-01 -9.1204860e-01 +266 4.77000e+01 8.9939028e-01 -8.8755096e-01 +267 4.78800e+01 1.0570181e+00 -8.6359746e-01 +268 4.80600e+01 1.2103833e+00 -8.4018812e-01 +269 4.82400e+01 1.3595838e+00 -8.1732293e-01 +270 4.84200e+01 1.5047175e+00 -7.9500187e-01 +271 4.86000e+01 1.6458824e+00 -7.7322498e-01 +272 4.87800e+01 1.7831764e+00 -7.5199223e-01 +273 4.89600e+01 1.9166976e+00 -7.3130363e-01 +274 4.91400e+01 2.0465437e+00 -7.1115919e-01 +275 4.93200e+01 2.1728128e+00 -6.9155888e-01 +276 4.95000e+01 2.2956028e+00 -6.7250272e-01 +277 4.96800e+01 2.4150117e+00 -6.5399073e-01 +278 4.98600e+01 2.5311375e+00 -6.3602289e-01 +279 5.00400e+01 2.6440779e+00 -6.1859916e-01 +280 5.02200e+01 2.7539311e+00 -6.0171962e-01 +281 5.04000e+01 2.8607949e+00 -5.8538422e-01 +282 5.05800e+01 2.9647674e+00 -5.6959295e-01 +283 5.07600e+01 3.0659463e+00 -5.5434585e-01 +284 5.09400e+01 3.1644298e+00 -5.3964290e-01 +285 5.11200e+01 3.2603157e+00 -5.2548408e-01 +286 5.13000e+01 3.3537020e+00 -5.1186943e-01 +287 5.14800e+01 3.4446867e+00 -4.9879893e-01 +288 5.16600e+01 3.5333676e+00 -4.8627255e-01 +289 5.18400e+01 3.6198427e+00 -4.7429035e-01 +290 5.20200e+01 3.7042101e+00 -4.6285229e-01 +291 5.22000e+01 3.7865675e+00 -4.5195837e-01 +292 5.23800e+01 3.8670130e+00 -4.4161003e-01 +293 5.25600e+01 3.9456446e+00 -4.3188395e-01 +294 5.27400e+01 4.0225591e+00 -4.2265255e-01 +295 5.29200e+01 4.0977975e+00 -4.1334526e-01 +296 5.31000e+01 4.1713149e+00 -4.0364940e-01 +297 5.32800e+01 4.2430591e+00 -3.9365327e-01 +298 5.34600e+01 4.3129779e+00 -3.8336719e-01 +299 5.36400e+01 4.3810191e+00 -3.7279118e-01 +300 5.38200e+01 4.4471306e+00 -3.6192527e-01 +301 5.40000e+01 4.5112600e+00 -3.5076941e-01 +302 5.41800e+01 4.5733554e+00 -3.3932361e-01 +303 5.43600e+01 4.6333643e+00 -3.2758791e-01 +304 5.45400e+01 4.6912348e+00 -3.1556227e-01 +305 5.47200e+01 4.7469146e+00 -3.0324669e-01 +306 5.49000e+01 4.8003514e+00 -2.9064119e-01 +307 5.50800e+01 4.8514932e+00 -2.7774577e-01 +308 5.52600e+01 4.9002877e+00 -2.6456043e-01 +309 5.54400e+01 4.9466828e+00 -2.5108513e-01 +310 5.56200e+01 4.9906262e+00 -2.3731992e-01 +311 5.58000e+01 5.0320658e+00 -2.2326479e-01 +312 5.59800e+01 5.0709493e+00 -2.0891973e-01 +313 5.61600e+01 5.1072247e+00 -1.9428474e-01 +314 5.63400e+01 5.1408396e+00 -1.7935982e-01 +315 5.65200e+01 5.1717420e+00 -1.6414496e-01 +316 5.67000e+01 5.1998796e+00 -1.4864017e-01 +317 5.68800e+01 5.2252003e+00 -1.3284549e-01 +318 5.70600e+01 5.2476518e+00 -1.1676084e-01 +319 5.72400e+01 5.2671820e+00 -1.0038629e-01 +320 5.74200e+01 5.2837387e+00 -8.3721799e-02 +321 5.76000e+01 5.2972697e+00 -6.6767354e-02 +322 5.77800e+01 5.3077228e+00 -4.9523048e-02 +323 5.79600e+01 5.3150458e+00 -3.1988751e-02 +324 5.81400e+01 5.3191865e+00 -1.4158719e-02 +325 5.83200e+01 5.3200928e+00 4.0811116e-03 +326 5.85000e+01 5.3177168e+00 2.2451136e-02 +327 5.86800e+01 5.3121051e+00 4.0169275e-02 +328 5.88600e+01 5.3033977e+00 5.6973873e-02 +329 5.90400e+01 5.2917382e+00 7.2974824e-02 +330 5.92200e+01 5.2772705e+00 8.8177269e-02 +331 5.94000e+01 5.2601381e+00 1.0258120e-01 +332 5.95800e+01 5.2404850e+00 1.1618669e-01 +333 5.97600e+01 5.2184547e+00 1.2899368e-01 +334 5.99400e+01 5.1941910e+00 1.4100213e-01 +335 6.01200e+01 5.1678376e+00 1.5221210e-01 +336 6.03000e+01 5.1395383e+00 1.6262367e-01 +337 6.04800e+01 5.1094368e+00 1.7223669e-01 +338 6.06600e+01 5.0776769e+00 1.8105113e-01 +339 6.08400e+01 5.0444021e+00 1.8906726e-01 +340 6.10200e+01 5.0097564e+00 1.9628480e-01 +341 6.12000e+01 4.9738834e+00 2.0270376e-01 +342 6.13800e+01 4.9369268e+00 2.0832442e-01 +343 6.15600e+01 4.8990303e+00 2.1314649e-01 +344 6.17400e+01 4.8603377e+00 2.1717002e-01 +345 6.19200e+01 4.8209928e+00 2.2039510e-01 +346 6.21000e+01 4.7811392e+00 2.2282179e-01 +347 6.22800e+01 4.7409207e+00 2.2444986e-01 +348 6.24600e+01 4.7004810e+00 2.2499622e-01 +349 6.26400e+01 4.6599638e+00 2.2499623e-01 +350 6.28200e+01 4.6195129e+00 2.2454334e-01 +351 6.30000e+01 4.5792720e+00 2.2297736e-01 +352 6.31800e+01 4.5393848e+00 2.2061311e-01 +353 6.33600e+01 4.4999950e+00 2.1745030e-01 +354 6.35400e+01 4.4612464e+00 2.1348890e-01 +355 6.37200e+01 4.4232827e+00 2.0872912e-01 +356 6.39000e+01 4.3862476e+00 2.0316042e-01 +357 6.40800e+01 4.3502849e+00 1.9668922e-01 +358 6.42600e+01 4.3155297e+00 1.8964640e-01 +359 6.44400e+01 4.2820197e+00 1.8270549e-01 +360 6.46200e+01 4.2497320e+00 1.7598157e-01 +361 6.48000e+01 4.2186422e+00 1.6939308e-01 +362 6.49800e+01 4.1887263e+00 1.6293898e-01 +363 6.51600e+01 4.1599600e+00 1.5661902e-01 +364 6.53400e+01 4.1323193e+00 1.5043324e-01 +365 6.55200e+01 4.1057799e+00 1.4438173e-01 +366 6.57000e+01 4.0803177e+00 1.3846450e-01 +367 6.58800e+01 4.0559085e+00 1.3268145e-01 +368 6.60600e+01 4.0325282e+00 1.2703254e-01 +369 6.62400e+01 4.0101527e+00 1.2151800e-01 +370 6.64200e+01 3.9887576e+00 1.1613761e-01 +371 6.66000e+01 3.9683190e+00 1.1089139e-01 +372 6.67800e+01 3.9488125e+00 1.0577952e-01 +373 6.69600e+01 3.9302142e+00 1.0080180e-01 +374 6.71400e+01 3.9124997e+00 9.5958273e-02 +375 6.73200e+01 3.8956450e+00 9.1249023e-02 +376 6.75000e+01 3.8796259e+00 8.6674023e-02 +377 6.76800e+01 3.8644182e+00 8.2233193e-02 +378 6.78600e+01 3.8499978e+00 7.7926573e-02 +379 6.80400e+01 3.8363405e+00 7.3754253e-02 +380 6.82200e+01 3.8234221e+00 6.9716094e-02 +381 6.84000e+01 3.8112185e+00 6.5812157e-02 +382 6.85800e+01 3.7997056e+00 6.2042498e-02 +383 6.87600e+01 3.7888591e+00 5.8407027e-02 +384 6.89400e+01 3.7786549e+00 5.4905770e-02 +385 6.91200e+01 3.7690688e+00 5.1538755e-02 +386 6.93000e+01 3.7600768e+00 4.8305968e-02 +387 6.94800e+01 3.7516545e+00 4.5207408e-02 +388 6.96600e+01 3.7437780e+00 4.2240286e-02 +389 6.98400e+01 3.7364229e+00 3.9394893e-02 +390 7.00200e+01 3.7295632e+00 3.6725615e-02 +391 7.02000e+01 3.7231608e+00 3.4299208e-02 +392 7.03800e+01 3.7171724e+00 3.2118193e-02 +393 7.05600e+01 3.7115552e+00 3.0176466e-02 +394 7.07400e+01 3.7062658e+00 2.8474044e-02 +395 7.09200e+01 3.7012614e+00 2.7010954e-02 +396 7.11000e+01 3.6964988e+00 2.5787161e-02 +397 7.12800e+01 3.6919350e+00 2.4802661e-02 +398 7.14600e+01 3.6875268e+00 2.4057474e-02 +399 7.16400e+01 3.6832312e+00 2.3551614e-02 +400 7.18200e+01 3.6790051e+00 2.3359584e-02 +401 7.20000e+01 3.6748055e+00 2.3359584e-02 +402 7.21800e+01 3.6705893e+00 2.3469823e-02 +403 7.23600e+01 3.6663133e+00 2.3921155e-02 +404 7.25400e+01 3.6619346e+00 2.4611803e-02 +405 7.27200e+01 3.6574100e+00 2.5541761e-02 +406 7.29000e+01 3.6526965e+00 2.6711050e-02 +407 7.30800e+01 3.6477509e+00 2.8119632e-02 +408 7.32600e+01 3.6425303e+00 2.9767477e-02 +409 7.34400e+01 3.6369916e+00 3.1654688e-02 +410 7.36200e+01 3.6310916e+00 3.3781187e-02 +411 7.38000e+01 3.6247873e+00 3.6146962e-02 +412 7.39800e+01 3.6180356e+00 3.8752091e-02 +413 7.41600e+01 3.6107934e+00 4.1596510e-02 +414 7.43400e+01 3.6030178e+00 4.4680221e-02 +415 7.45200e+01 3.5946655e+00 4.8003226e-02 +416 7.47000e+01 3.5856935e+00 5.1565583e-02 +417 7.48800e+01 3.5760588e+00 5.5367233e-02 +418 7.50600e+01 3.5657182e+00 5.9408132e-02 +419 7.52400e+01 3.5546288e+00 6.3688423e-02 +420 7.54200e+01 3.5427473e+00 6.8223879e-02 +421 7.56000e+01 3.5300308e+00 7.3029965e-02 +422 7.57800e+01 3.5164482e+00 7.7880892e-02 +423 7.59600e+01 3.5020142e+00 8.2553868e-02 +424 7.61400e+01 3.4867546e+00 8.7068515e-02 +425 7.63200e+01 3.4706953e+00 9.1439765e-02 +426 7.65000e+01 3.4538621e+00 9.5667672e-02 +427 7.66800e+01 3.4362808e+00 9.9752176e-02 +428 7.68600e+01 3.4179771e+00 1.0369322e-01 +429 7.70400e+01 3.3989770e+00 1.0749097e-01 +430 7.72200e+01 3.3793062e+00 1.1114530e-01 +431 7.74000e+01 3.3589905e+00 1.1465616e-01 +432 7.75800e+01 3.3380558e+00 1.1802375e-01 +433 7.77600e+01 3.3165278e+00 1.2124790e-01 +434 7.79400e+01 3.2944323e+00 1.2432860e-01 +435 7.81200e+01 3.2717953e+00 1.2726596e-01 +436 7.83000e+01 3.2486424e+00 1.3005998e-01 +437 7.84800e+01 3.2249995e+00 1.3271057e-01 +438 7.86600e+01 3.2008924e+00 1.3521770e-01 +439 7.88400e+01 3.1763469e+00 1.3758155e-01 +440 7.90200e+01 3.1513889e+00 1.3980196e-01 +441 7.92000e+01 3.1260440e+00 1.4187893e-01 +442 7.93800e+01 3.1003383e+00 1.4381262e-01 +443 7.95600e+01 3.0742973e+00 1.4560284e-01 +444 7.97400e+01 3.0479470e+00 1.4724966e-01 +445 7.99200e+01 3.0213132e+00 1.4875311e-01 +446 8.01000e+01 2.9944217e+00 1.5011321e-01 +447 8.02800e+01 2.9672983e+00 1.5132989e-01 +448 8.04600e+01 2.9399688e+00 1.5240312e-01 +449 8.06400e+01 2.9124590e+00 1.5333308e-01 +450 8.08200e+01 2.8847947e+00 1.5411956e-01 +451 8.10000e+01 2.8570018e+00 1.5476259e-01 +452 8.11800e+01 2.8291059e+00 1.5525096e-01 +453 8.13600e+01 2.8011331e+00 1.5559419e-01 +454 8.15400e+01 2.7731025e+00 1.5588274e-01 +455 8.17200e+01 2.7450184e+00 1.5617122e-01 +456 8.19000e+01 2.7168829e+00 1.5645093e-01 +457 8.20800e+01 2.6886982e+00 1.5671895e-01 +458 8.22600e+01 2.6604662e+00 1.5697527e-01 +459 8.24400e+01 2.6321891e+00 1.5722007e-01 +460 8.26200e+01 2.6038691e+00 1.5745319e-01 +461 8.28000e+01 2.5755081e+00 1.5767458e-01 +462 8.29800e+01 2.5471083e+00 1.5788447e-01 +463 8.31600e+01 2.5186718e+00 1.5808266e-01 +464 8.33400e+01 2.4902007e+00 1.5826915e-01 +465 8.35200e+01 2.4616970e+00 1.5844407e-01 +466 8.37000e+01 2.4331629e+00 1.5860740e-01 +467 8.38800e+01 2.4046004e+00 1.5875902e-01 +468 8.40600e+01 2.3760117e+00 1.5889896e-01 +469 8.42400e+01 2.3473989e+00 1.5902738e-01 +470 8.44200e+01 2.3187640e+00 1.5914408e-01 +471 8.46000e+01 2.2901091e+00 1.5924910e-01 +472 8.47800e+01 2.2614364e+00 1.5934261e-01 +473 8.49600e+01 2.2327479e+00 1.5942440e-01 +474 8.51400e+01 2.2040457e+00 1.5949452e-01 +475 8.53200e+01 2.1753319e+00 1.5955304e-01 +476 8.55000e+01 2.1466087e+00 1.5959998e-01 +477 8.56800e+01 2.1178780e+00 1.5963520e-01 +478 8.58600e+01 2.0891421e+00 1.5965876e-01 +479 8.60400e+01 2.0604030e+00 1.5966658e-01 +480 8.62200e+01 2.0316627e+00 1.5966658e-01 +481 8.64000e+01 2.0029235e+00 1.5965974e-01 +482 8.65800e+01 1.9741873e+00 1.5963685e-01 +483 8.67600e+01 1.9454563e+00 1.5960227e-01 +484 8.69400e+01 1.9167326e+00 1.5955568e-01 +485 8.71200e+01 1.8880182e+00 1.5949769e-01 +486 8.73000e+01 1.8593151e+00 1.5943103e-01 +487 8.74800e+01 1.8306245e+00 1.5935722e-01 +488 8.76600e+01 1.8019478e+00 1.5927573e-01 +489 8.78400e+01 1.7732866e+00 1.5918672e-01 +490 8.80200e+01 1.7446420e+00 1.5908999e-01 +491 8.82000e+01 1.7160156e+00 1.5898553e-01 +492 8.83800e+01 1.6874086e+00 1.5887355e-01 +493 8.85600e+01 1.6588225e+00 1.5875385e-01 +494 8.87400e+01 1.6302586e+00 1.5862645e-01 +495 8.89200e+01 1.6017183e+00 1.5849144e-01 +496 8.91000e+01 1.5732030e+00 1.5834881e-01 +497 8.92800e+01 1.5447141e+00 1.5819849e-01 +498 8.94600e+01 1.5162530e+00 1.5804046e-01 +499 8.96400e+01 1.4878209e+00 1.5787488e-01 +500 8.98200e+01 1.4594194e+00 1.5770159e-01 +501 9.00000e+01 1.4310497e+00 1.5752059e-01 +502 9.01800e+01 1.4027133e+00 1.5733204e-01 +503 9.03600e+01 1.3744116e+00 1.5713579e-01 +504 9.05400e+01 1.3461458e+00 1.5693182e-01 +505 9.07200e+01 1.3179175e+00 1.5672026e-01 +506 9.09000e+01 1.2897279e+00 1.5650109e-01 +507 9.10800e+01 1.2615785e+00 1.5627421e-01 +508 9.12600e+01 1.2334706e+00 1.5603961e-01 +509 9.14400e+01 1.2054056e+00 1.5579748e-01 +510 9.16200e+01 1.1773849e+00 1.5554764e-01 +511 9.18000e+01 1.1494098e+00 1.5529008e-01 +512 9.19800e+01 1.1214818e+00 1.5502498e-01 +513 9.21600e+01 1.0936022e+00 1.5475216e-01 +514 9.23400e+01 1.0657724e+00 1.5447165e-01 +515 9.25200e+01 1.0379938e+00 1.5418356e-01 +516 9.27000e+01 1.0102677e+00 1.5388859e-01 +517 9.28800e+01 9.8259561e-01 1.5358487e-01 +518 9.30600e+01 9.5497945e-01 1.5326767e-01 +519 9.32400e+01 9.2742181e-01 1.5293549e-01 +520 9.34200e+01 8.9992526e-01 1.5258888e-01 +521 9.36000e+01 8.7249240e-01 1.5222786e-01 +522 9.37800e+01 8.4512580e-01 1.5185262e-01 +523 9.39600e+01 8.1782804e-01 1.5146298e-01 +524 9.41400e+01 7.9060172e-01 1.5105894e-01 +525 9.43200e+01 7.6344940e-01 1.5064060e-01 +526 9.45000e+01 7.3637368e-01 1.5020796e-01 +527 9.46800e+01 7.0937712e-01 1.4976094e-01 +528 9.48600e+01 6.8246233e-01 1.4929951e-01 +529 9.50400e+01 6.5563187e-01 1.4882385e-01 +530 9.52200e+01 6.2888833e-01 1.4833379e-01 +531 9.54000e+01 6.0223430e-01 1.4782932e-01 +532 9.55800e+01 5.7567235e-01 1.4731063e-01 +533 9.57600e+01 5.4920506e-01 1.4677753e-01 +534 9.59400e+01 5.2283502e-01 1.4623004e-01 +535 9.61200e+01 4.9656482e-01 1.4566826e-01 +536 9.63000e+01 4.7039703e-01 1.4509217e-01 +537 9.64800e+01 4.4433422e-01 1.4450170e-01 +538 9.66600e+01 4.1837900e-01 1.4389682e-01 +539 9.68400e+01 3.9253394e-01 1.4327771e-01 +540 9.70200e+01 3.6680161e-01 1.4264420e-01 +541 9.72000e+01 3.4118462e-01 1.4199628e-01 +542 9.73800e+01 3.1568553e-01 1.4133414e-01 +543 9.75600e+01 2.9030691e-01 1.4065759e-01 +544 9.77400e+01 2.6505138e-01 1.3996665e-01 +545 9.79200e+01 2.3992150e-01 1.3926142e-01 +546 9.81000e+01 2.1491985e-01 1.3854188e-01 +547 9.82800e+01 1.9004901e-01 1.3780795e-01 +548 9.84600e+01 1.6531157e-01 1.3705966e-01 +549 9.86400e+01 1.4071012e-01 1.3629706e-01 +550 9.88200e+01 1.1624725e-01 1.3551985e-01 +551 9.90000e+01 9.1925599e-02 1.3472800e-01 +552 9.91800e+01 6.7747784e-02 1.3392168e-01 +553 9.93600e+01 4.3716420e-02 1.3310075e-01 +554 9.95400e+01 1.9834143e-02 1.3226519e-01 +555 9.97200e+01 -3.8964316e-03 1.3141512e-01 +556 9.99000e+01 -2.7472680e-02 1.3055051e-01 +557 1.00080e+02 -5.0891989e-02 1.2967129e-01 +558 1.00260e+02 -7.4151719e-02 1.2877745e-01 +559 1.00440e+02 -9.7249257e-02 1.2786915e-01 +560 1.00620e+02 -1.2018199e-01 1.2694622e-01 +561 1.00800e+02 -1.4294727e-01 1.2600867e-01 +562 1.00980e+02 -1.6554249e-01 1.2505666e-01 +563 1.01160e+02 -1.8796504e-01 1.2409002e-01 +564 1.01340e+02 -2.1021227e-01 1.2310877e-01 +565 1.01520e+02 -2.3228158e-01 1.2211300e-01 +566 1.01700e+02 -2.5417034e-01 1.2110269e-01 +567 1.01880e+02 -2.7587592e-01 1.2007778e-01 +568 1.02060e+02 -2.9739571e-01 1.1903825e-01 +569 1.02240e+02 -3.1872708e-01 1.1798424e-01 +570 1.02420e+02 -3.3986741e-01 1.1691561e-01 +571 1.02600e+02 -3.6081407e-01 1.1583237e-01 +572 1.02780e+02 -3.8156445e-01 1.1473465e-01 +573 1.02960e+02 -4.0211592e-01 1.1362232e-01 +574 1.03140e+02 -4.2246586e-01 1.1249538e-01 +575 1.03320e+02 -4.4261164e-01 1.1135391e-01 +576 1.03500e+02 -4.6255064e-01 1.1019790e-01 +577 1.03680e+02 -4.8228026e-01 1.0902729e-01 +578 1.03860e+02 -5.0179784e-01 1.0784206e-01 +579 1.04040e+02 -5.2110078e-01 1.0664221e-01 +580 1.04220e+02 -5.4018647e-01 1.0542714e-01 +581 1.04400e+02 -5.5905236e-01 1.0419964e-01 +582 1.04580e+02 -5.7769659e-01 1.0296342e-01 +583 1.04760e+02 -5.9611756e-01 1.0171847e-01 +584 1.04940e+02 -6.1431362e-01 1.0046448e-01 +585 1.05120e+02 -6.3228315e-01 9.9201492e-02 +586 1.05300e+02 -6.5002453e-01 9.7929512e-02 +587 1.05480e+02 -6.6753615e-01 9.6648481e-02 +588 1.05660e+02 -6.8481636e-01 9.5358391e-02 +589 1.05840e+02 -7.0186355e-01 9.4059355e-02 +590 1.06020e+02 -7.1867610e-01 9.2751257e-02 +591 1.06200e+02 -7.3525238e-01 9.1434101e-02 +592 1.06380e+02 -7.5159076e-01 9.0107998e-02 +593 1.06560e+02 -7.6768963e-01 8.8772834e-02 +594 1.06740e+02 -7.8354735e-01 8.7428622e-02 +595 1.06920e+02 -7.9916231e-01 8.6075416e-02 +596 1.07100e+02 -8.1453288e-01 8.4713213e-02 +597 1.07280e+02 -8.2965744e-01 8.3341966e-02 +598 1.07460e+02 -8.4453436e-01 8.1961658e-02 +599 1.07640e+02 -8.5916202e-01 8.0572396e-02 +600 1.07820e+02 -8.7353880e-01 7.9174081e-02 +601 1.08000e+02 -8.8766306e-01 7.7766710e-02 +602 1.08180e+02 -9.0153319e-01 7.6350381e-02 +603 1.08360e+02 -9.1514757e-01 7.4924999e-02 +604 1.08540e+02 -9.2850457e-01 7.3490572e-02 +605 1.08720e+02 -9.4160256e-01 7.2047146e-02 +606 1.08900e+02 -9.5443992e-01 7.0594719e-02 +607 1.09080e+02 -9.6701503e-01 6.9133250e-02 +608 1.09260e+02 -9.7932626e-01 6.7662732e-02 +609 1.09440e+02 -9.9137199e-01 6.6183242e-02 +610 1.09620e+02 -1.0031506e+00 6.4694710e-02 +611 1.09800e+02 -1.0146605e+00 6.3196356e-02 +612 1.09980e+02 -1.0258999e+00 6.1687720e-02 +613 1.10160e+02 -1.0368680e+00 6.0178958e-02 +614 1.10340e+02 -1.0475656e+00 5.8679814e-02 +615 1.10520e+02 -1.0579942e+00 5.7189432e-02 +616 1.10700e+02 -1.0681552e+00 5.5707154e-02 +617 1.10880e+02 -1.0780502e+00 5.4232947e-02 +618 1.11060e+02 -1.0876806e+00 5.2766814e-02 +619 1.11240e+02 -1.0970477e+00 5.1308811e-02 +620 1.11420e+02 -1.1061532e+00 4.9858868e-02 +621 1.11600e+02 -1.1149984e+00 4.8417006e-02 +622 1.11780e+02 -1.1235848e+00 4.6983272e-02 +623 1.11960e+02 -1.1319138e+00 4.5557597e-02 +624 1.12140e+02 -1.1399870e+00 4.4140014e-02 +625 1.12320e+02 -1.1478057e+00 4.2730528e-02 +626 1.12500e+02 -1.1553714e+00 4.1329140e-02 +627 1.12680e+02 -1.1626856e+00 3.9935837e-02 +628 1.12860e+02 -1.1697498e+00 3.8550600e-02 +629 1.13040e+02 -1.1765653e+00 3.7173492e-02 +630 1.13220e+02 -1.1831337e+00 3.5804457e-02 +631 1.13400e+02 -1.1894564e+00 3.4443490e-02 +632 1.13580e+02 -1.1955348e+00 3.3090646e-02 +633 1.13760e+02 -1.2013704e+00 3.1745881e-02 +634 1.13940e+02 -1.2069648e+00 3.0409192e-02 +635 1.14120e+02 -1.2123192e+00 2.9080603e-02 +636 1.14300e+02 -1.2174352e+00 2.7760113e-02 +637 1.14480e+02 -1.2223143e+00 2.6447704e-02 +638 1.14660e+02 -1.2269579e+00 2.5143376e-02 +639 1.14840e+02 -1.2313674e+00 2.3847157e-02 +640 1.15020e+02 -1.2355443e+00 2.2559018e-02 +641 1.15200e+02 -1.2394901e+00 2.1278961e-02 +642 1.15380e+02 -1.2432062e+00 2.0007004e-02 +643 1.15560e+02 -1.2466941e+00 1.8742761e-02 +644 1.15740e+02 -1.2499552e+00 1.7486524e-02 +645 1.15920e+02 -1.2529912e+00 1.6241800e-02 +646 1.16100e+02 -1.2558046e+00 1.5011056e-02 +647 1.16280e+02 -1.2583976e+00 1.3793797e-02 +648 1.16460e+02 -1.2607728e+00 1.2589897e-02 +649 1.16640e+02 -1.2629324e+00 1.1399383e-02 +650 1.16820e+02 -1.2648789e+00 1.0222240e-02 +651 1.17000e+02 -1.2666148e+00 9.0584625e-03 +652 1.17180e+02 -1.2681424e+00 7.9080625e-03 +653 1.17360e+02 -1.2694641e+00 6.7710417e-03 +654 1.17540e+02 -1.2705824e+00 5.6473791e-03 +655 1.17720e+02 -1.2714996e+00 4.5370973e-03 +656 1.17900e+02 -1.2722181e+00 3.4401860e-03 +657 1.18080e+02 -1.2727405e+00 2.3566459e-03 +658 1.18260e+02 -1.2730689e+00 1.2864861e-03 +659 1.18440e+02 -1.2732060e+00 2.2968470e-04 +660 1.18620e+02 -1.2731540e+00 -8.1373748e-04 +661 1.18800e+02 -1.2729155e+00 -1.8437819e-03 +662 1.18980e+02 -1.2724927e+00 -2.8604626e-03 +663 1.19160e+02 -1.2718881e+00 -3.8637638e-03 +664 1.19340e+02 -1.2711041e+00 -4.8536931e-03 +665 1.19520e+02 -1.2701432e+00 -5.8302555e-03 +666 1.19700e+02 -1.2690076e+00 -6.7934459e-03 +667 1.19880e+02 -1.2676999e+00 -7.7432583e-03 +668 1.20060e+02 -1.2662225e+00 -8.6796987e-03 +669 1.20240e+02 -1.2645777e+00 -9.6027750e-03 +670 1.20420e+02 -1.2627679e+00 -1.0512465e-02 +671 1.20600e+02 -1.2607956e+00 -1.1408790e-02 +672 1.20780e+02 -1.2586631e+00 -1.2291749e-02 +673 1.20960e+02 -1.2563730e+00 -1.3161329e-02 +674 1.21140e+02 -1.2539275e+00 -1.4017525e-02 +675 1.21320e+02 -1.2513290e+00 -1.4859989e-02 +676 1.21500e+02 -1.2485801e+00 -1.5689347e-02 +677 1.21680e+02 -1.2456828e+00 -1.6508237e-02 +678 1.21860e+02 -1.2426389e+00 -1.7317985e-02 +679 1.22040e+02 -1.2394501e+00 -1.8118197e-02 +680 1.22220e+02 -1.2361181e+00 -1.8908812e-02 +681 1.22400e+02 -1.2326446e+00 -1.9689850e-02 +682 1.22580e+02 -1.2290315e+00 -2.0461318e-02 +683 1.22760e+02 -1.2252803e+00 -2.1223183e-02 +684 1.22940e+02 -1.2213928e+00 -2.1975467e-02 +685 1.23120e+02 -1.2173708e+00 -2.2718178e-02 +686 1.23300e+02 -1.2132160e+00 -2.3451304e-02 +687 1.23480e+02 -1.2089301e+00 -2.4174843e-02 +688 1.23660e+02 -1.2045148e+00 -2.4888790e-02 +689 1.23840e+02 -1.1999719e+00 -2.5593175e-02 +690 1.24020e+02 -1.1953030e+00 -2.6287964e-02 +691 1.24200e+02 -1.1905099e+00 -2.6973156e-02 +692 1.24380e+02 -1.1855944e+00 -2.7648792e-02 +693 1.24560e+02 -1.1805581e+00 -2.8314829e-02 +694 1.24740e+02 -1.1754028e+00 -2.8971279e-02 +695 1.24920e+02 -1.1701301e+00 -2.9618151e-02 +696 1.25100e+02 -1.1647419e+00 -3.0255446e-02 +697 1.25280e+02 -1.1592399e+00 -3.0883151e-02 +698 1.25460e+02 -1.1536257e+00 -3.1501265e-02 +699 1.25640e+02 -1.1479012e+00 -3.2109817e-02 +700 1.25820e+02 -1.1420679e+00 -3.2708771e-02 +701 1.26000e+02 -1.1361277e+00 -3.3298135e-02 +702 1.26180e+02 -1.1300823e+00 -3.3877938e-02 +703 1.26360e+02 -1.1239334e+00 -3.4448137e-02 +704 1.26540e+02 -1.1176827e+00 -3.5008750e-02 +705 1.26720e+02 -1.1113320e+00 -3.5559787e-02 +706 1.26900e+02 -1.1048829e+00 -3.6101243e-02 +707 1.27080e+02 -1.0983373e+00 -3.6632801e-02 +708 1.27260e+02 -1.0916967e+00 -3.7155198e-02 +709 1.27440e+02 -1.0849627e+00 -3.7670333e-02 +710 1.27620e+02 -1.0781366e+00 -3.8178730e-02 +711 1.27800e+02 -1.0712197e+00 -3.8680133e-02 +712 1.27980e+02 -1.0642131e+00 -3.9174585e-02 +713 1.28160e+02 -1.0571181e+00 -3.9662035e-02 +714 1.28340e+02 -1.0499360e+00 -4.0142489e-02 +715 1.28520e+02 -1.0426680e+00 -4.0615960e-02 +716 1.28700e+02 -1.0353155e+00 -4.1082470e-02 +717 1.28880e+02 -1.0278796e+00 -4.1541976e-02 +718 1.29060e+02 -1.0203616e+00 -4.1994469e-02 +719 1.29240e+02 -1.0127628e+00 -4.2440025e-02 +720 1.29420e+02 -1.0050845e+00 -4.2878573e-02 +721 1.29600e+02 -9.9732782e-01 -4.3310116e-02 +722 1.29780e+02 -9.8949410e-01 -4.3734706e-02 +723 1.29960e+02 -9.8158458e-01 -4.4152294e-02 +724 1.30140e+02 -9.7360053e-01 -4.4562883e-02 +725 1.30320e+02 -9.6554320e-01 -4.4966498e-02 +726 1.30500e+02 -9.5741385e-01 -4.5363141e-02 +727 1.30680e+02 -9.4921373e-01 -4.5752786e-02 +728 1.30860e+02 -9.4094411e-01 -4.6135424e-02 +729 1.31040e+02 -9.3260623e-01 -4.6511114e-02 +730 1.31220e+02 -9.2420136e-01 -4.6879800e-02 +731 1.31400e+02 -9.1573076e-01 -4.7241480e-02 +732 1.31580e+02 -9.0719569e-01 -4.7596212e-02 +733 1.31760e+02 -8.9859739e-01 -4.7943937e-02 +734 1.31940e+02 -8.8993713e-01 -4.8284663e-02 +735 1.32120e+02 -8.8121616e-01 -4.8618417e-02 +736 1.32300e+02 -8.7243575e-01 -4.8945202e-02 +737 1.32480e+02 -8.6359715e-01 -4.9264982e-02 +738 1.32660e+02 -8.5470162e-01 -4.9577706e-02 +739 1.32840e+02 -8.4575041e-01 -4.9883053e-02 +740 1.33020e+02 -8.3674475e-01 -5.0182410e-02 +741 1.33200e+02 -8.2768547e-01 -5.0478215e-02 +742 1.33380e+02 -8.1857321e-01 -5.0770926e-02 +743 1.33560e+02 -8.0940856e-01 -5.1060192e-02 +744 1.33740e+02 -8.0019216e-01 -5.1346014e-02 +745 1.33920e+02 -7.9092461e-01 -5.1628425e-02 +746 1.34100e+02 -7.8160654e-01 -5.1907427e-02 +747 1.34280e+02 -7.7223855e-01 -5.2182981e-02 +748 1.34460e+02 -7.6282128e-01 -5.2455089e-02 +749 1.34640e+02 -7.5335534e-01 -5.2723810e-02 +750 1.34820e+02 -7.4384133e-01 -5.2989081e-02 +751 1.35000e+02 -7.3427989e-01 -5.3250905e-02 +752 1.35180e+02 -7.2467162e-01 -5.3509343e-02 +753 1.35360e+02 -7.1501714e-01 -5.3764332e-02 +754 1.35540e+02 -7.0531708e-01 -5.4015876e-02 +755 1.35720e+02 -6.9557204e-01 -5.4264010e-02 +756 1.35900e+02 -6.8578265e-01 -5.4508734e-02 +757 1.36080e+02 -6.7594952e-01 -5.4750010e-02 +758 1.36260e+02 -6.6607326e-01 -5.4987839e-02 +759 1.36440e+02 -6.5615451e-01 -5.5222284e-02 +760 1.36620e+02 -6.4619386e-01 -5.5453277e-02 +761 1.36800e+02 -6.3619195e-01 -5.5680823e-02 +762 1.36980e+02 -6.2614938e-01 -5.5904985e-02 +763 1.37160e+02 -6.1606677e-01 -5.6125695e-02 +764 1.37340e+02 -6.0594475e-01 -5.6342960e-02 +765 1.37520e+02 -5.9578392e-01 -5.6556816e-02 +766 1.37700e+02 -5.8558491e-01 -5.6767263e-02 +767 1.37880e+02 -5.7534832e-01 -5.6974263e-02 +768 1.38060e+02 -5.6507479e-01 -5.7177812e-02 +769 1.38240e+02 -5.5476492e-01 -5.7377979e-02 +770 1.38420e+02 -5.4441934e-01 -5.7574527e-02 +771 1.38600e+02 -5.3403865e-01 -5.7766980e-02 +772 1.38780e+02 -5.2362336e-01 -5.7958495e-02 +773 1.38960e+02 -5.1317326e-01 -5.8152824e-02 +774 1.39140e+02 -5.0268788e-01 -5.8350080e-02 +775 1.39320e+02 -4.9216677e-01 -5.8549940e-02 +776 1.39500e+02 -4.8160944e-01 -5.8752403e-02 +777 1.39680e+02 -4.7101544e-01 -5.8957432e-02 +778 1.39860e+02 -4.6038430e-01 -5.9165021e-02 +779 1.40040e+02 -4.4971556e-01 -5.9375242e-02 +780 1.40220e+02 -4.3900875e-01 -5.9588024e-02 +781 1.40400e+02 -4.2826341e-01 -5.9803368e-02 +782 1.40580e+02 -4.1747907e-01 -6.0021345e-02 +783 1.40760e+02 -4.0665526e-01 -6.0241883e-02 +784 1.40940e+02 -3.9579153e-01 -6.0464983e-02 +785 1.41120e+02 -3.8488740e-01 -6.0690690e-02 +786 1.41300e+02 -3.7394241e-01 -6.0919001e-02 +787 1.41480e+02 -3.6295610e-01 -6.1149876e-02 +788 1.41660e+02 -3.5192799e-01 -6.1383312e-02 +789 1.41840e+02 -3.4085763e-01 -6.1619382e-02 +790 1.42020e+02 -3.2974455e-01 -6.1858011e-02 +791 1.42200e+02 -3.1858829e-01 -6.2099201e-02 +792 1.42380e+02 -3.0738837e-01 -6.2343025e-02 +793 1.42560e+02 -2.9614433e-01 -6.2589409e-02 +794 1.42740e+02 -2.8485572e-01 -6.2838357e-02 +795 1.42920e+02 -2.7352206e-01 -6.3089911e-02 +796 1.43100e+02 -2.6214288e-01 -6.3344069e-02 +797 1.43280e+02 -2.5071773e-01 -6.3600791e-02 +798 1.43460e+02 -2.3924614e-01 -6.3860073e-02 +799 1.43640e+02 -2.2772763e-01 -6.4121991e-02 +800 1.43820e+02 -2.1616176e-01 -6.4386468e-02 +801 1.44000e+02 -2.0454804e-01 -6.4653504e-02 +802 1.44180e+02 -1.9288603e-01 -6.4923496e-02 +803 1.44360e+02 -1.8117524e-01 -6.5196551e-02 +804 1.44540e+02 -1.6941545e-01 -6.5468516e-02 +805 1.44720e+02 -1.5760725e-01 -6.5735587e-02 +806 1.44900e+02 -1.4575140e-01 -6.5998160e-02 +807 1.45080e+02 -1.3384868e-01 -6.6256440e-02 +808 1.45260e+02 -1.2189986e-01 -6.6510420e-02 +809 1.45440e+02 -1.0990570e-01 -6.6760180e-02 +810 1.45620e+02 -9.7866964e-02 -6.7005641e-02 +811 1.45800e+02 -8.5784437e-02 -6.7246802e-02 +812 1.45980e+02 -7.3658880e-02 -6.7483745e-02 +813 1.46160e+02 -6.1491060e-02 -6.7716387e-02 +814 1.46340e+02 -4.9281752e-02 -6.7944735e-02 +815 1.46520e+02 -3.7031722e-02 -6.8168832e-02 +816 1.46700e+02 -2.4741740e-02 -6.8388679e-02 +817 1.46880e+02 -1.2412569e-02 -6.8604230e-02 +818 1.47060e+02 -4.4987875e-05 -6.8815481e-02 +819 1.47240e+02 1.2360239e-02 -6.9022515e-02 +820 1.47420e+02 2.4802346e-02 -6.9225248e-02 +821 1.47600e+02 3.7280557e-02 -6.9423681e-02 +822 1.47780e+02 4.9794106e-02 -6.9617897e-02 +823 1.47960e+02 6.2342229e-02 -6.9807811e-02 +824 1.48140e+02 7.4924147e-02 -6.9993431e-02 +825 1.48320e+02 8.7539097e-02 -7.0174801e-02 +826 1.48500e+02 1.0018631e-01 -7.0351921e-02 +827 1.48680e+02 1.1286502e-01 -7.0524744e-02 +828 1.48860e+02 1.2557445e-01 -7.0693267e-02 +829 1.49040e+02 1.3831383e-01 -7.0857574e-02 +830 1.49220e+02 1.5108240e-01 -7.1017579e-02 +831 1.49400e+02 1.6387939e-01 -7.1173284e-02 +832 1.49580e+02 1.7670402e-01 -7.1324773e-02 +833 1.49760e+02 1.8955553e-01 -7.1471958e-02 +834 1.49940e+02 2.0243315e-01 -7.1614594e-02 +835 1.50120e+02 2.1533611e-01 -7.1752951e-02 +836 1.50300e+02 2.2826383e-01 -7.1889340e-02 +837 1.50480e+02 2.4121610e-01 -7.2025285e-02 +838 1.50660e+02 2.5419278e-01 -7.2160459e-02 +839 1.50840e+02 2.6719372e-01 -7.2294879e-02 +840 1.51020e+02 2.8021879e-01 -7.2428454e-02 +841 1.51200e+02 2.9326782e-01 -7.2561187e-02 +842 1.51380e+02 3.0634067e-01 -7.2693167e-02 +843 1.51560e+02 3.1943721e-01 -7.2824303e-02 +844 1.51740e+02 3.3255727e-01 -7.2954601e-02 +845 1.51920e+02 3.4570072e-01 -7.3084110e-02 +846 1.52100e+02 3.5886741e-01 -7.3212830e-02 +847 1.52280e+02 3.7205719e-01 -7.3340712e-02 +848 1.52460e+02 3.8526992e-01 -7.3467752e-02 +849 1.52640e+02 3.9850544e-01 -7.3594039e-02 +850 1.52820e+02 4.1176362e-01 -7.3719479e-02 +851 1.53000e+02 4.2504431e-01 -7.3844079e-02 +852 1.53180e+02 4.3834735e-01 -7.3967925e-02 +853 1.53360e+02 4.5167261e-01 -7.4090928e-02 +854 1.53540e+02 4.6501994e-01 -7.4213093e-02 +855 1.53720e+02 4.7838918e-01 -7.4334469e-02 +856 1.53900e+02 4.9178020e-01 -7.4455055e-02 +857 1.54080e+02 5.0519285e-01 -7.4574803e-02 +858 1.54260e+02 5.1862698e-01 -7.4693709e-02 +859 1.54440e+02 5.3208244e-01 -7.4811861e-02 +860 1.54620e+02 5.4555910e-01 -7.4929171e-02 +861 1.54800e+02 5.5905680e-01 -7.5045636e-02 +862 1.54980e+02 5.7257539e-01 -7.5161348e-02 +863 1.55160e+02 5.8611473e-01 -7.5276217e-02 +864 1.55340e+02 5.9967468e-01 -7.5390248e-02 +865 1.55520e+02 6.1325508e-01 -7.5503508e-02 +866 1.55700e+02 6.2685579e-01 -7.5616730e-02 +867 1.55880e+02 6.4047666e-01 -7.5728565e-02 +868 1.56060e+02 6.5411696e-01 -7.5833518e-02 +869 1.56240e+02 6.6777523e-01 -7.5929200e-02 +870 1.56420e+02 6.8144994e-01 -7.6016303e-02 +871 1.56600e+02 6.9513957e-01 -7.6094907e-02 +872 1.56780e+02 7.0884259e-01 -7.6165093e-02 +873 1.56960e+02 7.2255747e-01 -7.6226769e-02 +874 1.57140e+02 7.3628270e-01 -7.6279953e-02 +875 1.57320e+02 7.5001673e-01 -7.6324680e-02 +876 1.57500e+02 7.6375806e-01 -7.6360964e-02 +877 1.57680e+02 7.7750515e-01 -7.6388730e-02 +878 1.57860e+02 7.9125648e-01 -7.6408009e-02 +879 1.58040e+02 8.0501051e-01 -7.6417185e-02 +880 1.58220e+02 8.1876574e-01 -7.6417185e-02 +881 1.58400e+02 8.3252062e-01 -7.6415064e-02 +882 1.58580e+02 8.4627364e-01 -7.6400486e-02 +883 1.58760e+02 8.6002327e-01 -7.6377423e-02 +884 1.58940e+02 8.7376799e-01 -7.6345843e-02 +885 1.59120e+02 8.8750625e-01 -7.6305819e-02 +886 1.59300e+02 9.0123656e-01 -7.6257337e-02 +887 1.59480e+02 9.1495737e-01 -7.6200364e-02 +888 1.59660e+02 9.2866716e-01 -7.6134879e-02 +889 1.59840e+02 9.4236440e-01 -7.6060980e-02 +890 1.60020e+02 9.5604758e-01 -7.5978581e-02 +891 1.60200e+02 9.6971516e-01 -7.5887668e-02 +892 1.60380e+02 9.8336562e-01 -7.5788342e-02 +893 1.60560e+02 9.9699744e-01 -7.5680516e-02 +894 1.60740e+02 1.0106091e+00 -7.5564182e-02 +895 1.60920e+02 1.0241990e+00 -7.5439401e-02 +896 1.61100e+02 1.0377657e+00 -7.5306167e-02 +897 1.61280e+02 1.0513077e+00 -7.5164450e-02 +898 1.61460e+02 1.0648234e+00 -7.5014389e-02 +899 1.61640e+02 1.0783113e+00 -7.4855639e-02 +900 1.61820e+02 1.0917697e+00 -7.4687031e-02 +901 1.62000e+02 1.1051968e+00 -7.4508182e-02 +902 1.62180e+02 1.1185908e+00 -7.4319356e-02 +903 1.62360e+02 1.1319500e+00 -7.4120465e-02 +904 1.62540e+02 1.1452724e+00 -7.3911513e-02 +905 1.62720e+02 1.1585563e+00 -7.3692566e-02 +906 1.62900e+02 1.1717999e+00 -7.3463595e-02 +907 1.63080e+02 1.1850014e+00 -7.3224578e-02 +908 1.63260e+02 1.1981590e+00 -7.2975497e-02 +909 1.63440e+02 1.2112708e+00 -7.2716437e-02 +910 1.63620e+02 1.2243351e+00 -7.2447323e-02 +911 1.63800e+02 1.2373500e+00 -7.2168144e-02 +912 1.63980e+02 1.2503138e+00 -7.1878988e-02 +913 1.64160e+02 1.2632246e+00 -7.1579771e-02 +914 1.64340e+02 1.2760807e+00 -7.1270501e-02 +915 1.64520e+02 1.2888802e+00 -7.0951227e-02 +916 1.64700e+02 1.3016214e+00 -7.0621933e-02 +917 1.64880e+02 1.3143023e+00 -7.0282585e-02 +918 1.65060e+02 1.3269213e+00 -6.9933179e-02 +919 1.65240e+02 1.3394765e+00 -6.9573801e-02 +920 1.65420e+02 1.3519660e+00 -6.9204355e-02 +921 1.65600e+02 1.3643882e+00 -6.8824851e-02 +922 1.65780e+02 1.3767412e+00 -6.8435377e-02 +923 1.65960e+02 1.3890231e+00 -6.8035828e-02 +924 1.66140e+02 1.4012323e+00 -6.7626234e-02 +925 1.66320e+02 1.4133668e+00 -6.7206635e-02 +926 1.66500e+02 1.4254249e+00 -6.6777016e-02 +927 1.66680e+02 1.4374047e+00 -6.6337343e-02 +928 1.66860e+02 1.4493045e+00 -6.5887612e-02 +929 1.67040e+02 1.4611224e+00 -6.5428144e-02 +930 1.67220e+02 1.4728567e+00 -6.4960391e-02 +931 1.67400e+02 1.4845054e+00 -6.4478113e-02 +932 1.67580e+02 1.4960648e+00 -6.3970704e-02 +933 1.67760e+02 1.5075302e+00 -6.3436333e-02 +934 1.67940e+02 1.5188972e+00 -6.2876336e-02 +935 1.68120e+02 1.5301611e+00 -6.2290756e-02 +936 1.68300e+02 1.5413173e+00 -6.1679602e-02 +937 1.68480e+02 1.5523612e+00 -6.1042848e-02 +938 1.68660e+02 1.5632881e+00 -6.0380457e-02 +939 1.68840e+02 1.5740935e+00 -5.9692522e-02 +940 1.69020e+02 1.5847728e+00 -5.8978977e-02 +941 1.69200e+02 1.5953213e+00 -5.8239815e-02 +942 1.69380e+02 1.6057345e+00 -5.7475096e-02 +943 1.69560e+02 1.6160078e+00 -5.6684763e-02 +944 1.69740e+02 1.6261364e+00 -5.5868818e-02 +945 1.69920e+02 1.6361159e+00 -5.5027296e-02 +946 1.70100e+02 1.6459417e+00 -5.4160196e-02 +947 1.70280e+02 1.6556090e+00 -5.3267485e-02 +948 1.70460e+02 1.6651133e+00 -5.2349160e-02 +949 1.70640e+02 1.6744501e+00 -5.1405275e-02 +950 1.70820e+02 1.6836146e+00 -5.0435782e-02 +951 1.71000e+02 1.6926024e+00 -4.9440674e-02 +952 1.71180e+02 1.7014087e+00 -4.8420007e-02 +953 1.71360e+02 1.7100290e+00 -4.7373725e-02 +954 1.71540e+02 1.7184586e+00 -4.6301837e-02 +955 1.71720e+02 1.7266930e+00 -4.5204374e-02 +956 1.71900e+02 1.7347276e+00 -4.4081319e-02 +957 1.72080e+02 1.7425577e+00 -4.2932661e-02 +958 1.72260e+02 1.7501787e+00 -4.1758394e-02 +959 1.72440e+02 1.7575861e+00 -4.0558562e-02 +960 1.72620e+02 1.7647752e+00 -3.9333116e-02 +961 1.72800e+02 1.7717414e+00 -3.8080384e-02 +962 1.72980e+02 1.7784801e+00 -3.6795821e-02 +963 1.73160e+02 1.7849880e+00 -3.5510058e-02 +964 1.73340e+02 1.7912686e+00 -3.4260553e-02 +965 1.73520e+02 1.7973278e+00 -3.3047568e-02 +966 1.73700e+02 1.8031717e+00 -3.1867827e-02 +967 1.73880e+02 1.8088062e+00 -3.0721315e-02 +968 1.74060e+02 1.8142373e+00 -2.9608017e-02 +969 1.74240e+02 1.8194711e+00 -2.8527982e-02 +970 1.74420e+02 1.8245134e+00 -2.7481161e-02 +971 1.74600e+02 1.8293703e+00 -2.6467563e-02 +972 1.74780e+02 1.8340477e+00 -2.5487220e-02 +973 1.74960e+02 1.8385516e+00 -2.4540096e-02 +974 1.75140e+02 1.8428881e+00 -2.3626201e-02 +975 1.75320e+02 1.8470630e+00 -2.2745547e-02 +976 1.75500e+02 1.8510825e+00 -2.1898128e-02 +977 1.75680e+02 1.8549524e+00 -2.1083930e-02 +978 1.75860e+02 1.8586787e+00 -2.0302968e-02 +979 1.76040e+02 1.8622674e+00 -1.9555246e-02 +980 1.76220e+02 1.8657245e+00 -1.8840753e-02 +981 1.76400e+02 1.8690561e+00 -1.8159482e-02 +982 1.76580e+02 1.8722679e+00 -1.7511452e-02 +983 1.76760e+02 1.8753662e+00 -1.6896662e-02 +984 1.76940e+02 1.8783567e+00 -1.6315089e-02 +985 1.77120e+02 1.8812456e+00 -1.5766750e-02 +986 1.77300e+02 1.8840387e+00 -1.5251659e-02 +987 1.77480e+02 1.8867422e+00 -1.4769787e-02 +988 1.77660e+02 1.8893618e+00 -1.4321146e-02 +989 1.77840e+02 1.8919037e+00 -1.3905746e-02 +990 1.78020e+02 1.8943739e+00 -1.3523574e-02 +991 1.78200e+02 1.8967782e+00 -1.3174629e-02 +992 1.78380e+02 1.8991227e+00 -1.2858927e-02 +993 1.78560e+02 1.9014134e+00 -1.2576451e-02 +994 1.78740e+02 1.9036562e+00 -1.2327206e-02 +995 1.78920e+02 1.9058572e+00 -1.2111194e-02 +996 1.79100e+02 1.9080222e+00 -1.1928418e-02 +997 1.79280e+02 1.9101574e+00 -1.1778874e-02 +998 1.79460e+02 1.9122686e+00 -1.1662552e-02 +999 1.79640e+02 1.9143619e+00 -1.1579483e-02 +1000 1.79820e+02 1.9164432e+00 -1.1540710e-02 +1001 1.80000e+02 1.9185186e+00 -1.1513008e-02 From 27524742e571a8d690b1868378ff9ce5a5ec82ed Mon Sep 17 00:00:00 2001 From: Christoph Scherer Date: Thu, 26 May 2022 14:14:08 +0200 Subject: [PATCH 216/585] src/MANYBODY/pair_3b_table.h, src/MANYBODY/pair_3b_table.cpp: added pair style for generic fully tabulated three-body forces which has been developed for simulations with Kernel-based machine learning potentials. --- src/MANYBODY/pair_3b_table.cpp | 861 +++++++++++++++++++++++++++++++++ src/MANYBODY/pair_3b_table.h | 138 ++++++ 2 files changed, 999 insertions(+) create mode 100644 src/MANYBODY/pair_3b_table.cpp create mode 100644 src/MANYBODY/pair_3b_table.h diff --git a/src/MANYBODY/pair_3b_table.cpp b/src/MANYBODY/pair_3b_table.cpp new file mode 100644 index 0000000000..a2227d5161 --- /dev/null +++ b/src/MANYBODY/pair_3b_table.cpp @@ -0,0 +1,861 @@ +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +/* ---------------------------------------------------------------------- + Contributing author: Christoph Scherer (MPIP Mainz) + scherer@mpip-mainz.mpg.de +------------------------------------------------------------------------- */ + +#include "pair_3b_table.h" + +#include "atom.h" +#include "comm.h" +#include "error.h" +#include "force.h" +#include "math_const.h" +#include "memory.h" +#include "neigh_list.h" +#include "neighbor.h" +#include "table_file_reader.h" +#include "potential_file_reader.h" + +#include +#include +// +#include + +using namespace LAMMPS_NS; +using MathConst::MY_PI; + +#define DELTA 4 + +enum{LINEAR}; + +#define SMALL 0.001 +#define TINY 1.E-10 + +/* ---------------------------------------------------------------------- */ + +Pair3BTable::Pair3BTable(LAMMPS *lmp) : Pair(lmp) +{ + single_enable = 0; + restartinfo = 0; + one_coeff = 1; + manybody_flag = 1; + centroidstressflag = CENTROID_NOTAVAIL; + unit_convert_flag = utils::get_supported_conversions(utils::ENERGY); + + params = nullptr; + + maxshort = 10; + neighshort = nullptr; +} + +/* ---------------------------------------------------------------------- + check if allocated, since class can be destructed when incomplete +------------------------------------------------------------------------- */ + +Pair3BTable::~Pair3BTable() +{ + if (copymode) return; + + for (int m = 0; m < nparams; m++) free_param(¶ms[m]); // free_param will call free_table + memory->sfree(params); + memory->destroy(elem3param); + + if (allocated) { + memory->destroy(setflag); + memory->destroy(cutsq); + memory->destroy(neighshort); + } +} + +/* ---------------------------------------------------------------------- */ + +void Pair3BTable::compute(int eflag, int vflag) +{ + int i,j,k,ii,jj,kk,inum,jnum,jnumm1; + int itype,jtype,ktype,ijparam,ikparam,ijkparam; + tagint itag,jtag; + double xtmp,ytmp,ztmp,delx,dely,delz,evdwl,fpair; + double rsq,rsq1,rsq2; + double delr1[3],delr2[3],fi[3],fj[3],fk[3]; + int *ilist,*jlist,*numneigh,**firstneigh; + + evdwl = 0.0; + ev_init(eflag,vflag); + + double **x = atom->x; + double **f = atom->f; + tagint *tag = atom->tag; + int *type = atom->type; + int nlocal = atom->nlocal; + int newton_pair = force->newton_pair; + + inum = list->inum; + ilist = list->ilist; + numneigh = list->numneigh; + firstneigh = list->firstneigh; + + double fxtmp,fytmp,fztmp; + + // loop over full neighbor list of my atoms + + for (ii = 0; ii < inum; ii++) { + i = ilist[ii]; + itag = tag[i]; + itype = map[type[i]]; + xtmp = x[i][0]; + ytmp = x[i][1]; + ztmp = x[i][2]; + fxtmp = fytmp = fztmp = 0.0; + + // two-body interactions, skip half of them + + jlist = firstneigh[i]; + jnum = numneigh[i]; + int numshort = 0; + + for (jj = 0; jj < jnum; jj++) { + j = jlist[jj]; + j &= NEIGHMASK; + + delx = xtmp - x[j][0]; + dely = ytmp - x[j][1]; + delz = ztmp - x[j][2]; + rsq = delx*delx + dely*dely + delz*delz; + + jtype = map[type[j]]; + ijparam = elem3param[itype][jtype][jtype]; + if (rsq >= params[ijparam].cutsq) { + continue; + } else { + neighshort[numshort++] = j; + if (numshort >= maxshort) { + maxshort += maxshort/2; + memory->grow(neighshort,maxshort,"pair:neighshort"); + } + } + + jtag = tag[j]; + if (itag > jtag) { + if ((itag+jtag) % 2 == 0) continue; + } else if (itag < jtag) { + if ((itag+jtag) % 2 == 1) continue; + } else { + if (x[j][2] < ztmp) continue; + if (x[j][2] == ztmp && x[j][1] < ytmp) continue; + if (x[j][2] == ztmp && x[j][1] == ytmp && x[j][0] < xtmp) continue; + } + + //two-body interactions are not computed + } + + jnumm1 = numshort - 1; + + for (jj = 0; jj < jnumm1; jj++) { + j = neighshort[jj]; + jtype = map[type[j]]; + ijparam = elem3param[itype][jtype][jtype]; + delr1[0] = x[j][0] - xtmp; + delr1[1] = x[j][1] - ytmp; + delr1[2] = x[j][2] - ztmp; + rsq1 = delr1[0]*delr1[0] + delr1[1]*delr1[1] + delr1[2]*delr1[2]; + + double fjxtmp,fjytmp,fjztmp; + fjxtmp = fjytmp = fjztmp = 0.0; + + for (kk = jj+1; kk < numshort; kk++) { + k = neighshort[kk]; + ktype = map[type[k]]; + ikparam = elem3param[itype][ktype][ktype]; + ijkparam = elem3param[itype][jtype][ktype]; + + delr2[0] = x[k][0] - xtmp; + delr2[1] = x[k][1] - ytmp; + delr2[2] = x[k][2] - ztmp; + rsq2 = delr2[0]*delr2[0] + delr2[1]*delr2[1] + delr2[2]*delr2[2]; + + threebody(¶ms[ijparam],¶ms[ikparam],¶ms[ijkparam], + rsq1,rsq2,delr1,delr2,fi,fj,fk,eflag,evdwl); + + fxtmp += fi[0]; + fytmp += fi[1]; + fztmp += fi[2]; + fjxtmp += fj[0]; + fjytmp += fj[1]; + fjztmp += fj[2]; + f[k][0] += fk[0]; + f[k][1] += fk[1]; + f[k][2] += fk[2]; + + if (evflag) ev_tally3(i,j,k,evdwl,0.0,fj,fk,delr1,delr2); + } + f[j][0] += fjxtmp; + f[j][1] += fjytmp; + f[j][2] += fjztmp; + } + f[i][0] += fxtmp; + f[i][1] += fytmp; + f[i][2] += fztmp; + } + + if (vflag_fdotr) virial_fdotr_compute(); +} + +/* ---------------------------------------------------------------------- */ + +void Pair3BTable::allocate() +{ + allocated = 1; + int n = atom->ntypes; + + memory->create(setflag,n+1,n+1,"pair:setflag"); + memory->create(cutsq,n+1,n+1,"pair:cutsq"); + memory->create(neighshort,maxshort,"pair:neighshort"); + map = new int[n+1]; +} + +/* ---------------------------------------------------------------------- + global settings +------------------------------------------------------------------------- */ + +void Pair3BTable::settings(int narg, char **arg) +{ + //one mre additional argument: number of table entries + if (narg != 0) error->all(FLERR,"Illegal pair_style command"); +} + +/* ---------------------------------------------------------------------- + set coeffs for one or more type pairs +------------------------------------------------------------------------- */ + +void Pair3BTable::coeff(int narg, char **arg) +{ + if (!allocated) allocate(); + + map_element2type(narg-3,arg+3); + + // read potential file and initialize potential parameters + + read_file(arg[2]); + setup_params(); +} + +/* ---------------------------------------------------------------------- + init specific to this pair style +------------------------------------------------------------------------- */ + +void Pair3BTable::init_style() +{ + if (atom->tag_enable == 0) + error->all(FLERR,"Pair style 3b/table requires atom IDs"); + if (force->newton_pair == 0) + error->all(FLERR,"Pair style 3b/table requires newton pair on"); + + // need a full neighbor list + + neighbor->add_request(this, NeighConst::REQ_FULL); +} + +/* ---------------------------------------------------------------------- + init for one type pair i,j and corresponding j,i +------------------------------------------------------------------------- */ + +double Pair3BTable::init_one(int i, int j) +{ + if (setflag[i][j] == 0) error->all(FLERR,"All pair coeffs are not set"); + + return cutmax; +} + +/* ---------------------------------------------------------------------- */ + +void Pair3BTable::read_file(char *file) +{ + memory->sfree(params); + params = nullptr; + nparams = maxparam = 0; + + // open file on proc 0 + + if (comm->me == 0) { + PotentialFileReader reader(lmp, file, "3b", unit_convert_flag); + char *line; + + // transparently convert units for supported conversions + + int unit_convert = reader.get_unit_convert(); + double conversion_factor = utils::get_conversion_factor(utils::ENERGY, + unit_convert); + + while ((line = reader.next_line(NPARAMS_PER_LINE))) { + try { + ValueTokenizer values(line); + + std::string iname = values.next_string(); + std::string jname = values.next_string(); + std::string kname = values.next_string(); + + // ielement,jelement,kelement = 1st args + // if all 3 args are in element list, then parse this line + // else skip to next entry in file + int ielement, jelement, kelement; + + for (ielement = 0; ielement < nelements; ielement++) + if (iname == elements[ielement]) break; + if (ielement == nelements) continue; + for (jelement = 0; jelement < nelements; jelement++) + if (jname == elements[jelement]) break; + if (jelement == nelements) continue; + for (kelement = 0; kelement < nelements; kelement++) + if (kname == elements[kelement]) break; + if (kelement == nelements) continue; + + // load up parameter settings and error check their values + + if (nparams == maxparam) { + maxparam += DELTA; + params = (Param *) memory->srealloc(params,maxparam*sizeof(Param), + "pair:params"); + + // make certain all addional allocated storage is initialized + // to avoid false positives when checking with valgrind + + memset(params + nparams, 0, DELTA*sizeof(Param)); + } + + params[nparams].ielement = ielement; + params[nparams].jelement = jelement; + params[nparams].kelement = kelement; + // if jelement = kelement, symmetric is true, if not then it is false + params[nparams].symmetric = false; + if (params[nparams].jelement == params[nparams].kelement) params[nparams].symmetric = true; + // read cut off + params[nparams].cut = values.next_double(); + + // read parameters of angle table + std::string tablename_string = values.next_string(); + params[nparams].tablenamelength = tablename_string.length()+1; + memory->create(params[nparams].tablename, params[nparams].tablenamelength, "params.tablename"); + for (int x = 0; x < params[nparams].tablenamelength; ++x) { + params[nparams].tablename[x] = tablename_string[x]; + } + std::string keyword_string = values.next_string(); + params[nparams].keywordlength = keyword_string.length()+1; + memory->create(params[nparams].keyword, params[nparams].keywordlength, "params.keyword"); + for (int x = 0; x < params[nparams].keywordlength; ++x) { + params[nparams].keyword[x] = keyword_string[x]; + } + std::string tablestyle_string = values.next_string(); + char *tablestyle; + memory->create(tablestyle, (tablestyle_string.length()+1), "tablestyle"); + for (int x = 0; x < (tablestyle_string.length()+1); ++x) { + tablestyle[x] = tablestyle_string[x]; + } + if (strcmp(tablestyle,"linear") == 0) params[nparams].tabstyle = LINEAR; + else error->all(FLERR,"Unknown table style in 3b table"); + params[nparams].tablength = values.next_int(); + + } catch (TokenizerException &e) { + error->one(FLERR, e.what()); + } + + if (params[nparams].cut < 0.0 || params[nparams].tablength < 0.0) + error->one(FLERR,"Illegal 3b/table parameters"); + + nparams++; + } + } + + MPI_Bcast(&nparams, 1, MPI_INT, 0, world); + MPI_Bcast(&maxparam, 1, MPI_INT, 0, world); + + if (comm->me != 0) { + params = (Param *) memory->srealloc(params,maxparam*sizeof(Param), "pair:params"); + } + + MPI_Bcast(params, maxparam*sizeof(Param), MPI_BYTE, 0, world); + + // for each set of parameters, broadcast table name and keyword and read 3b table + for (int m = 0; m < nparams; ++m){ + if (comm->me != 0) { + memory->create(params[m].tablename, params[m].tablenamelength, "params.tablename"); + } + MPI_Bcast(¶ms[m].tablename, params[m].tablenamelength, MPI_CHAR, 0, world); + if (comm->me != 0) { + memory->create(params[m].keyword, params[m].keywordlength, "params.keyword"); + } + MPI_Bcast(¶ms[m].keyword, params[m].keywordlength, MPI_CHAR, 0, world); + + // initialize 3btable + memory->create(params[m].mltable,1,"param:3btable"); + null_table(params[m].mltable); + + //call read_table to read corresponding tabulated 3b file (only called by process 0) + if (comm->me == 0){ + read_table(params[m].mltable,params[m].tablename,params[m].keyword,params[m].symmetric); + } + + // broadcast read in 3btable to all processes + bcast_table(params[m].mltable,params[m].symmetric); + + // error check on table parameters + if (params[m].mltable->ninput <= 1) error->one(FLERR,"Invalid 3b table length"); + } +} + + +/* ---------------------------------------------------------------------- */ + +void Pair3BTable::setup_params() +{ + int i,j,k,m,n; + double rtmp; + + // set elem3param for all triplet combinations + // must be a single exact match to lines read from file + // do not allow for ACB in place of ABC + + memory->destroy(elem3param); + memory->create(elem3param,nelements,nelements,nelements,"pair:elem3param"); + + for (i = 0; i < nelements; i++) + for (j = 0; j < nelements; j++) + for (k = 0; k < nelements; k++) { + n = -1; + for (m = 0; m < nparams; m++) { + if (i == params[m].ielement && j == params[m].jelement && + k == params[m].kelement) { + if (n >= 0) error->all(FLERR,"Potential file has duplicate entry"); + n = m; + } + } + if (n < 0) error->all(FLERR,"Potential file is missing an entry"); + elem3param[i][j][k] = n; + } + + + // compute parameter values derived from inputs + + // set cutsq using shortcut to reduce neighbor list for accelerated + // calculations. cut must remain unchanged as it is a potential parameter + // (cut = a) + + for (m = 0; m < nparams; m++) { + rtmp = params[m].cut; + params[m].cutsq = rtmp * rtmp; + } + + + // set cutmax to max of all params + + cutmax = 0.0; + for (m = 0; m < nparams; m++) { + rtmp = sqrt(params[m].cutsq); + if (rtmp > cutmax) cutmax = rtmp; + } +} + +/* ---------------------------------------------------------------------- + read table file, only called by proc 0 +------------------------------------------------------------------------- */ + +void Pair3BTable::read_table(Table *tb, char *file, char *keyword, bool symmetric) +{ + TableFileReader reader(lmp, file, "3body"); + + char *line = reader.find_section_start(keyword); + + if (!line) { error->one(FLERR, "Did not find keyword in table file"); } + + // read args on 2nd line of section + // allocate table arrays for file values + + line = reader.next_line(); + param_extract(tb, line); + + // if it is a symmetric 3body interaction, less table entries are required + if (symmetric == true){ + memory->create(tb->r12file,tb->ninput*tb->ninput*(tb->ninput+1),"mltable:r12file"); + memory->create(tb->r13file,tb->ninput*tb->ninput*(tb->ninput+1),"mltable:r13file"); + memory->create(tb->thetafile,tb->ninput*tb->ninput*(tb->ninput+1),"mltable:thetafile"); + memory->create(tb->f11file,tb->ninput*tb->ninput*(tb->ninput+1),"mltable:f11file"); + memory->create(tb->f12file,tb->ninput*tb->ninput*(tb->ninput+1),"mltable:f12file"); + memory->create(tb->f21file,tb->ninput*tb->ninput*(tb->ninput+1),"mltable:f21file"); + memory->create(tb->f22file,tb->ninput*tb->ninput*(tb->ninput+1),"mltable:f22file"); + memory->create(tb->f31file,tb->ninput*tb->ninput*(tb->ninput+1),"mltable:f31file"); + memory->create(tb->f32file,tb->ninput*tb->ninput*(tb->ninput+1),"mltable:f32file"); + memory->create(tb->efile,tb->ninput*tb->ninput*(tb->ninput+1),"mltable:efile"); + } + // else, more (full) table entries are required + else{ + memory->create(tb->r12file,2*tb->ninput*tb->ninput*tb->ninput,"mltable:r12file"); + memory->create(tb->r13file,2*tb->ninput*tb->ninput*tb->ninput,"mltable:r13file"); + memory->create(tb->thetafile,2*tb->ninput*tb->ninput*tb->ninput,"mltable:thetafile"); + memory->create(tb->f11file,2*tb->ninput*tb->ninput*tb->ninput,"mltable:f11file"); + memory->create(tb->f12file,2*tb->ninput*tb->ninput*tb->ninput,"mltable:f12file"); + memory->create(tb->f21file,2*tb->ninput*tb->ninput*tb->ninput,"mltable:f21file"); + memory->create(tb->f22file,2*tb->ninput*tb->ninput*tb->ninput,"mltable:f22file"); + memory->create(tb->f31file,2*tb->ninput*tb->ninput*tb->ninput,"mltable:f31file"); + memory->create(tb->f32file,2*tb->ninput*tb->ninput*tb->ninput,"mltable:f32file"); + memory->create(tb->efile,2*tb->ninput*tb->ninput*tb->ninput,"mltable:efile"); + } + + + // read 3b table values from file + + int cerror = 0; + reader.skip_line(); + // if it is a symmetric 3body interaction, less table entries are required + if (symmetric == true){ + for (int i = 0; i < tb->ninput*tb->ninput*(tb->ninput+1); i++) { + line = reader.next_line(11); + try { + ValueTokenizer values(line); + values.next_int(); + tb->r12file[i] = values.next_double(); + tb->r13file[i] = values.next_double(); + tb->thetafile[i] = values.next_double(); + tb->f11file[i] = values.next_double(); + tb->f12file[i] = values.next_double(); + tb->f21file[i] = values.next_double(); + tb->f22file[i] = values.next_double(); + tb->f31file[i] = values.next_double(); + tb->f32file[i] = values.next_double(); + tb->efile[i] = values.next_double(); + } catch (TokenizerException &) { + ++cerror; + } + } + } + else{ + for (int i = 0; i < 2*tb->ninput*tb->ninput*tb->ninput; i++) { + line = reader.next_line(11); + try { + ValueTokenizer values(line); + values.next_int(); + tb->r12file[i] = values.next_double(); + tb->r13file[i] = values.next_double(); + tb->thetafile[i] = values.next_double(); + tb->f11file[i] = values.next_double(); + tb->f12file[i] = values.next_double(); + tb->f21file[i] = values.next_double(); + tb->f22file[i] = values.next_double(); + tb->f31file[i] = values.next_double(); + tb->f32file[i] = values.next_double(); + tb->efile[i] = values.next_double(); + } catch (TokenizerException &) { + ++cerror; + } + } + } + + // warn if data was read incompletely, e.g. columns were missing + + if (cerror) + error->warning(FLERR, "{} of {} lines in table incomplete or could not be parsed", cerror, + tb->ninput); +} + +/* ---------------------------------------------------------------------- + extract attributes from parameter line in table section + format of line: N value FP fplo fphi EQ theta0 + N is required, other params are optional + + only called by read_table, only called by proc 0 +------------------------------------------------------------------------- */ + +void Pair3BTable::param_extract(Table *tb, char *line) +{ + tb->ninput = 0; + tb->rmin = 0.0; + tb->rmax = 0.0; + + try { + ValueTokenizer values(line); + + while (values.has_next()) { + std::string word = values.next_string(); + + if (word == "N") { + tb->ninput = values.next_int(); + } else if (word == "rmin") { + tb->rmin = values.next_double(); + } else if (word == "rmax") { + tb->rmax = values.next_double(); + } else { + error->one(FLERR, "Invalid keyword in angle table parameters"); + } + } + } catch (TokenizerException &e) { + error->one(FLERR, e.what()); + } + + if (tb->ninput == 0) error->one(FLERR, "3body table parameters did not set N"); + if (tb->rmin == 0.0) error->one(FLERR, "3body table parameters did not set rmin"); + if (tb->rmax == 0.0) error->one(FLERR, "3body table parameters did not set rmax"); +} + + +/* ---------------------------------------------------------------------- + broadcast read-in table info from proc 0 to other procs + this function communicates these values in Table: + ninput,afile,efile,ffile,fpflag,fplo,fphi,theta0 +------------------------------------------------------------------------- */ + +void Pair3BTable::bcast_table(Table *tb, bool symmetric) +{ + MPI_Bcast(&tb->ninput,1,MPI_INT,0,world); + + int me; + MPI_Comm_rank(world, &me); + if (me > 0) { + // if it is a symmetric 3body interaction, less table entries are required + if (symmetric == true){ + memory->create(tb->r12file,tb->ninput*tb->ninput*(tb->ninput+1),"mltable:r12file"); + memory->create(tb->r13file,tb->ninput*tb->ninput*(tb->ninput+1),"mltable:r13file"); + memory->create(tb->thetafile,tb->ninput*tb->ninput*(tb->ninput+1),"mltable:thetafile"); + memory->create(tb->f11file,tb->ninput*tb->ninput*(tb->ninput+1),"mltable:f11file"); + memory->create(tb->f12file,tb->ninput*tb->ninput*(tb->ninput+1),"mltable:f12file"); + memory->create(tb->f21file,tb->ninput*tb->ninput*(tb->ninput+1),"mltable:f21file"); + memory->create(tb->f22file,tb->ninput*tb->ninput*(tb->ninput+1),"mltable:f22file"); + memory->create(tb->f31file,tb->ninput*tb->ninput*(tb->ninput+1),"mltable:f31file"); + memory->create(tb->f32file,tb->ninput*tb->ninput*(tb->ninput+1),"mltable:f32file"); + memory->create(tb->efile,tb->ninput*tb->ninput*(tb->ninput+1),"mltable:efile"); + } + // else, more (full) table entries are required + else{ + memory->create(tb->r12file,2*tb->ninput*tb->ninput*tb->ninput,"mltable:r12file"); + memory->create(tb->r13file,2*tb->ninput*tb->ninput*tb->ninput,"mltable:r13file"); + memory->create(tb->thetafile,2*tb->ninput*tb->ninput*tb->ninput,"mltable:thetafile"); + memory->create(tb->f11file,2*tb->ninput*tb->ninput*tb->ninput,"mltable:f11file"); + memory->create(tb->f12file,2*tb->ninput*tb->ninput*tb->ninput,"mltable:f12file"); + memory->create(tb->f21file,2*tb->ninput*tb->ninput*tb->ninput,"mltable:f21file"); + memory->create(tb->f22file,2*tb->ninput*tb->ninput*tb->ninput,"mltable:f22file"); + memory->create(tb->f31file,2*tb->ninput*tb->ninput*tb->ninput,"mltable:f31file"); + memory->create(tb->f32file,2*tb->ninput*tb->ninput*tb->ninput,"mltable:f32file"); + memory->create(tb->efile,2*tb->ninput*tb->ninput*tb->ninput,"mltable:efile"); + } + } + + // if it is a symmetric 3body interaction, less table entries are required + if (symmetric == true){ + MPI_Bcast(tb->r12file,tb->ninput*tb->ninput*(tb->ninput+1),MPI_DOUBLE,0,world); + MPI_Bcast(tb->r13file,tb->ninput*tb->ninput*(tb->ninput+1),MPI_DOUBLE,0,world); + MPI_Bcast(tb->thetafile,tb->ninput*tb->ninput*(tb->ninput+1),MPI_DOUBLE,0,world); + MPI_Bcast(tb->f11file,tb->ninput*tb->ninput*(tb->ninput+1),MPI_DOUBLE,0,world); + MPI_Bcast(tb->f12file,tb->ninput*tb->ninput*(tb->ninput+1),MPI_DOUBLE,0,world); + MPI_Bcast(tb->f21file,tb->ninput*tb->ninput*(tb->ninput+1),MPI_DOUBLE,0,world); + MPI_Bcast(tb->f22file,tb->ninput*tb->ninput*(tb->ninput+1),MPI_DOUBLE,0,world); + MPI_Bcast(tb->f31file,tb->ninput*tb->ninput*(tb->ninput+1),MPI_DOUBLE,0,world); + MPI_Bcast(tb->f32file,tb->ninput*tb->ninput*(tb->ninput+1),MPI_DOUBLE,0,world); + MPI_Bcast(tb->efile,tb->ninput*tb->ninput*(tb->ninput+1),MPI_DOUBLE,0,world); + } + // else, more (full) table entries are required + else{ + MPI_Bcast(tb->r12file,2*tb->ninput*tb->ninput*tb->ninput,MPI_DOUBLE,0,world); + MPI_Bcast(tb->r13file,2*tb->ninput*tb->ninput*tb->ninput,MPI_DOUBLE,0,world); + MPI_Bcast(tb->thetafile,2*tb->ninput*tb->ninput*tb->ninput,MPI_DOUBLE,0,world); + MPI_Bcast(tb->f11file,2*tb->ninput*tb->ninput*tb->ninput,MPI_DOUBLE,0,world); + MPI_Bcast(tb->f12file,2*tb->ninput*tb->ninput*tb->ninput,MPI_DOUBLE,0,world); + MPI_Bcast(tb->f21file,2*tb->ninput*tb->ninput*tb->ninput,MPI_DOUBLE,0,world); + MPI_Bcast(tb->f22file,2*tb->ninput*tb->ninput*tb->ninput,MPI_DOUBLE,0,world); + MPI_Bcast(tb->f31file,2*tb->ninput*tb->ninput*tb->ninput,MPI_DOUBLE,0,world); + MPI_Bcast(tb->f32file,2*tb->ninput*tb->ninput*tb->ninput,MPI_DOUBLE,0,world); + MPI_Bcast(tb->efile,2*tb->ninput*tb->ninput*tb->ninput,MPI_DOUBLE,0,world); + } + + MPI_Bcast(&tb->rmin,1,MPI_DOUBLE,0,world); + MPI_Bcast(&tb->rmax,1,MPI_DOUBLE,0,world); +} + +/* ---------------------------------------------------------------------- */ + +void Pair3BTable::free_param(Param *pm) +{ + // call free_table to destroy associated 3btable + free_table(pm->mltable); + // then destroy associated 3btable + memory->sfree(pm->mltable); +} + +/* ---------------------------------------------------------------------- */ + +void Pair3BTable::free_table(Table *tb) +{ + memory->destroy(tb->r12file); + memory->destroy(tb->r13file); + memory->destroy(tb->thetafile); + memory->destroy(tb->f11file); + memory->destroy(tb->f12file); + memory->destroy(tb->f21file); + memory->destroy(tb->f22file); + memory->destroy(tb->f31file); + memory->destroy(tb->f32file); + memory->destroy(tb->efile); +} + +/* ---------------------------------------------------------------------- */ + +void Pair3BTable::null_table(Table *tb) +{ + tb->r12file = tb->r13file = tb->thetafile = nullptr; + tb->f11file = tb->f12file = nullptr; + tb->f21file = tb->f22file = nullptr; + tb->f31file = tb->f32file = nullptr; + tb->efile = nullptr; +} + +/* ---------------------------------------------------------------------- + calculate potential u and force f at angle x +------------------------------------------------------------------------- */ + +void Pair3BTable::uf_lookup(Param *pm, double r12, double r13, double theta, double &f11, double &f12, double &f21, double &f22, double &f31, double &f32, double &u) +{ + int i,itable,nr12,nr13,ntheta; + double dr,dtheta; + dr = (pm->mltable->rmax - pm->mltable->rmin)/(pm->mltable->ninput-1); + dtheta = (180.0-0.0)/(pm->mltable->ninput*2); + + //lookup scheme + + if (pm->tabstyle == LINEAR) { + // if it is a symmetric 3body interaction, less table entries are required + if (pm->symmetric == true){ + nr12 = (r12 - pm->mltable->rmin + 0.5*dr - 0.00000001)/dr; + if (r12 == (pm->mltable->rmin - 0.5*dr)){ + nr12 = 0; + } + nr13 = (r13 - pm->mltable->rmin + 0.5*dr - 0.00000001)/dr; + if (r13 == (pm->mltable->rmin - 0.5*dr)){ + nr13 = 0; + } + nr13 -= nr12; + ntheta = (theta-0.00000001)/dtheta; + if (theta == 180.0){ + ntheta = 79; + } + itable = 0; + for (i=0; imltable->ninput-i); + } + itable += nr13; + itable *= (pm->mltable->ninput*2); + itable += ntheta; + } + // else, more (full) table entries are required + else{ + nr12 = (r12 - pm->mltable->rmin + 0.5*dr - 0.00000001)/dr; + if (r12 == (pm->mltable->rmin - 0.5*dr)){ + nr12 = 0; + } + nr13 = (r13 - pm->mltable->rmin + 0.5*dr - 0.00000001)/dr; + if (r13 == (pm->mltable->rmin - 0.5*dr)){ + nr13 = 0; + } + ntheta = (theta-0.00000001)/dtheta; + if (theta == 180.0){ + ntheta = 79; + } + itable = nr12*(pm->mltable->ninput); + itable += nr13; + itable *= (pm->mltable->ninput*2); + itable += ntheta; + } + + f11=pm->mltable->f11file[itable]; + f12=pm->mltable->f12file[itable]; + f21=pm->mltable->f21file[itable]; + f22=pm->mltable->f22file[itable]; + f31=pm->mltable->f31file[itable]; + f32=pm->mltable->f32file[itable]; + } +} + +/* ---------------------------------------------------------------------- */ + +void Pair3BTable::threebody(Param *paramij, Param *paramik, Param *paramijk, + double rsq1, double rsq2, + double *delr1, double *delr2, + double *fi, double *fj, double *fk, int eflag, double &eng) +{ + double r12,r13,theta,rinv,cs; + + double f11,f12,f21,f22,f31,f32,u,temp; + bool swapped; + double dr; + dr = (paramijk->mltable->rmax - paramijk->mltable->rmin)/(paramijk->mltable->ninput-1); + + //if swap indices or not + swapped = false; + + r12 = sqrt(rsq1); + r13 = sqrt(rsq2); + rinv = 1.0/(r12*r13); + cs = (delr1[0]*delr2[0] + delr1[1]*delr2[1] + delr1[2]*delr2[2]) * rinv; + //compute angle between r12 and r13 in degrees + theta = acos(cs)*180.0/MY_PI; + + //if r12 > r13 swap them, as in lookup table always r13 > r12 do to symmetry reasons + if (r12 > r13){ + temp = r12; + r12 = r13; + r13 = temp; + swapped = true; + } + + //look up forces and energy in table belonging to parameter set paramijk + + //only do lookup and add three-body interactions if r12 and r13 are both between rmin and rmax + + if ( (r12 >= (paramijk->mltable->rmin - 0.5*dr)) && (r13 <= (paramijk->mltable->rmax + 0.5*dr)) && (r13 >= (paramijk->mltable->rmin - 0.5*dr)) && (r13 <= (paramijk->mltable->rmax + 0.5*dr)) ){ + uf_lookup(paramijk, r12, r13, theta, f11, f12, f21, f22, f31, f32, u); + } + else{ + f11 = f12 = f21 = f22 = f31 = f32 = u = 0.0; + } + + // if the indices have been swapped, swap tehm back + if (swapped == true){ + temp = r12; + r12 = r13; + r13 = temp; + temp = f11; + f11 = f12; + f12 = temp; + temp = f21; + f21 = f31; + f31 = temp; + temp = f22; + f22 = -f32; + f32 = -temp; + } + + fi[0] = delr1[0]*f11+delr2[0]*f12; + fi[1] = delr1[1]*f11+delr2[1]*f12; + fi[2] = delr1[2]*f11+delr2[2]*f12; + + fj[0] = delr1[0]*f21+(delr2[0]-delr1[0])*f22; + fj[1] = delr1[1]*f21+(delr2[1]-delr1[1])*f22; + fj[2] = delr1[2]*f21+(delr2[2]-delr1[2])*f22; + + fk[0] = delr2[0]*f31+(delr2[0]-delr1[0])*f32; + fk[1] = delr2[1]*f31+(delr2[1]-delr1[1])*f32; + fk[2] = delr2[2]*f31+(delr2[2]-delr1[2])*f32; + + double epsilon = 0.5; + double epsilon2 = epsilon*epsilon; + + if (eflag) eng = u; +} diff --git a/src/MANYBODY/pair_3b_table.h b/src/MANYBODY/pair_3b_table.h new file mode 100644 index 0000000000..a864a9602c --- /dev/null +++ b/src/MANYBODY/pair_3b_table.h @@ -0,0 +1,138 @@ +/* -*- c++ -*- ---------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#ifdef PAIR_CLASS + +PairStyle(3b/table,Pair3BTable) + +#else + +#ifndef LMP_PAIR_3B_TABLE_H +#define LMP_PAIR_3B_TABLE_H + +#include "pair.h" + +namespace LAMMPS_NS { + +class Pair3BTable : public Pair { + public: + Pair3BTable(class LAMMPS *); + ~Pair3BTable() override; + void compute(int, int) override; + void coeff(int, char **) override; + double init_one(int, int) override; + void init_style() override; + + static constexpr int NPARAMS_PER_LINE = 8; + + // no write or read from binary restart file + + // struct for 3b/table + struct Table { + int ninput; + double rmin,rmax; + double *r12file,*r13file,*thetafile,*f11file,*f12file,*f21file,*f22file,*f31file,*f32file,*efile; + }; + + struct Param { + double cut,cutsq; + int ielement,jelement,kelement; + bool symmetric; // whether it is a symmetric table or not + int tablenamelength; // length of table name + char *tablename; // name of associated angular table + int keywordlength; // length of key in table + char *keyword; // key in table + int tabstyle,tablength; // length of interpolation table (not ninput) and style + Table *mltable; // 3b Table + }; + + protected: + double cutmax; // max cutoff for all elements + Param *params; // parameter set for an I-J-K interaction + int maxshort; // size of short neighbor list array + int *neighshort; // short neighbor list array + + void settings(int, char **) override; + virtual void allocate(); + void read_file(char *); + virtual void setup_params(); + void threebody(Param *, Param *, Param *, double, double, double *, double *, + double *, double *, double *, int, double &); + + void read_table(Table *, char *, char *, bool); + void bcast_table(Table *, bool); + void null_table(Table *); + + void free_table(Table *); + void free_param(Param *); + + void param_extract(Table *, char *); + + void uf_lookup(Param *, double, double, double, double &, double &, double &, double &, double &, double &, double &); +}; + +} + + +#endif +#endif + +/* ERROR/WARNING messages: + +E: Illegal ... command + +Self-explanatory. Check the input script syntax and compare to the +documentation for the command. You can use -echo screen as a +command-line option when running LAMMPS to see the offending line. + +E: Incorrect args for pair coefficients + +Self-explanatory. Check the input script or data file. + +E: Pair style 3b/table requires atom IDs + +This is a requirement to use the 3b/table potential. + +E: Pair style 3b/table requires newton pair on + +See the newton command. This is a restriction to use the 3b/table +potential. + +E: All pair coeffs are not set + +All pair coefficients must be set in the data file or by the +pair_coeff command before running a simulation. + +E: Cannot open 3b/table potential file %s + +The specified 3b/table potential file cannot be opened. Check that the path +and name are correct. + +E: Incorrect format in 3b/table potential file + +Incorrect number of words per line in the potential file. + +E: Illegal 3b/table parameter + +One or more of the coefficients defined in the potential file is +invalid. + +E: Potential file has duplicate entry + +The potential file has more than one entry for the same element. + +E: Potential file is missing an entry + +The potential file does not have a needed entry. + +*/ From f9fbc7f94b6e1168f02dea1e807362285858d405 Mon Sep 17 00:00:00 2001 From: Christoph Scherer Date: Thu, 26 May 2022 14:17:36 +0200 Subject: [PATCH 217/585] doc/src/pair_3b_table.rst: documentation for added pair style 3b/table --- doc/src/pair_3b_table.rst | 265 ++++++++++++++++++++++++++++++++++++++ 1 file changed, 265 insertions(+) create mode 100644 doc/src/pair_3b_table.rst diff --git a/doc/src/pair_3b_table.rst b/doc/src/pair_3b_table.rst new file mode 100644 index 0000000000..77d2dc7f1b --- /dev/null +++ b/doc/src/pair_3b_table.rst @@ -0,0 +1,265 @@ +.. index:: pair_style 3b_table + +pair_style 3b/table command +=========================== + +Syntax +"""""" + +.. code-block:: LAMMPS + + pair_style style + +* style = *3b/table* + + +Examples +"""""""" + +.. code-block:: LAMMPS + + pair_style 3b/table + pair_coeff * * spce.3b type + pair_coeff * * GaN.3b Ga N Ga + + +Description +""""""""""" + +The *3b/table* style is a pair style for generic tabulated three-body interactions. +It has been developed for (coarse-grained) simulations (of water) +with Kernel-based machine learning (ML) potentials (:ref:`Scherer2 `). +As for the pair style :doc:`pair_style sw ` +or :doc:`pair_style sw/table `, the energy of a system +is computed as a sum over three-body terms: + +.. math:: + + E = \sum_i \sum_{j \neq i} \sum_{k > j} \phi_3 (r_{ij}, r_{ik}, \theta_{ijk}) + +The summations in the formula are over all neighbors J +and K of atom I within a cutoff distance :math:`cut`. +In contrast to the Stillinger-Weber potential, all forces are not calculated analytically, but +read in from a three-body force/energy table which can be generated with +the csg_ml app of VOTCA as available at: . + +Only a single pair_coeff command is used with the *3b/table* style +which specifies a three-body potential (".3b") file with parameters for all +needed elements. These are then mapped to LAMMPS atom types by specifying +N_el additional arguments after the ".3b" filename in the pair_coeff command, +where N_el is the number of LAMMPS atom types: + +* ".3b" filename +* N_el element names = mapping of 3b elements to atom types + +See the :doc:`pair_coeff ` page for alternate ways +to specify the path for the potential file. + +As an example, imagine a file SiC.3b has three-body values for +Si and C. If your LAMMPS simulation has 4 atoms types and you want +the first 3 to be Si, and the fourth to be C, you would use the following +pair_coeff command: + +.. code-block:: LAMMPS + + pair_coeff * * SiC.3b Si Si Si C + +The first 2 arguments must be \* \* so as to span all LAMMPS atom types. +The first three Si arguments map LAMMPS atom types 1,2,3 to the Si +element in the ".3b" file. The final C argument maps LAMMPS atom type 4 +to the C element in the 3b file. If a mapping value is specified as +NULL, the mapping is not performed. This can be used when a *3b/table* +potential is used as part of the *hybrid* pair style. The NULL values +are placeholders for atom types that will be used with other +potentials. + +The three-body files have a ".3b" suffix. Lines that are not blank or +comments (starting with #) define parameters for a triplet of +elements. The parameters in a single entry specify to the +(three-body) cutoff distance and the tabulated +three-body interaction. A single entry then contains: + +* element 1 (the center atom in a 3-body interaction) +* element 2 +* element 3 +* cut (distance units) +* filename +* keyword +* style +* N + +The parameter :math:`cut` is the (three-body) cutoff distance. +When set to 0, no interaction is calculated for this element triplet. +The parameters *filename*, *keyword*, *style*, and *N* refer to +the tabulated three-body potential. + +The tabulation is done on a three-dimensional grid of the two distances +:math:`r_{ij}` and :math:`r_{ik}` as well as the angle :math:`\theta_{ijk}` +which is constructed in the following way. There are two different cases. +If element 2 and element 3 are of the same type (e.g. SiCC), the distance +:math:`r_{ij}` is varied in "N" steps from rmin to rmax and the distance +:math:`r_{ik}` is varied from :math:`r_{ij}` to rmax. This can be done, +due to the symmetry of the triplet. If element 2 and element 3 are not +of the same type (e.g. SiCSi), there is no additional symmetry and the +distance :math:`r_{ik}` is also varied from rmin to rmax in "N" steps. +The angle :math:`\theta_{ijk}` is alsways varied in "2N" steps from +(0.0 + 180.0/(4N)) to (180.0 - 180.0/(4N)). Therefore, the total number +of table entries is "M = N * N * (N+1)" for the symmetric (element 2 and element 3 +are of the same type) and "M = 2 * N * N * N" for the general case +(element 2 and element 3 are not of the same type). + +The forces on all three particles I, J, and K of a triplet +of this type of thre-body interaction potential +(:math:`\phi_3 (r_{ij}, r_{ik}, \theta_{ijk})`) lie within +the plane defined by the three inter-particle distance vectors +:math:`{\mathbf r}_{ij}`, :math:`{\mathbf r}_{ik}`, and :math:`{\mathbf r}_{jk}`. +This property is used to project the forces onto the inter-particle +distance vectors as follows + +.. math:: + + \begin{pmatrix} + {\mathbf f}_{i} \\ + {\mathbf f}_{j} \\ + {\mathbf f}_{k} \\ + \end{pmatrix} = + \begin{pmatrix} + f_{i1} & f_{i2} & 0 \\ + f_{j1} & 0 & f_{j2} \\ + 0 & f_{k1} & f_{k2} \\ + \end{pmatrix} + \begin{pmatrix} + {\mathbf r}_{ij} \\ + {\mathbf r}_{ik} \\ + {\mathbf r}_{jk} \\ + \end{pmatrix} + +and then tabulate the 6 force constants :math:`f_{i1}`, :math:`f_{i2}`, :math:`f_{j1}`, +:math:`f_{j2}`, :math:`f_{k1}`, and :math:`f_{k2}`, as well as the energy of a triplet e. +Due to symmetry reasons, the following relations hold: :math:`f_{i1}=-f_{j1}`, +:math:`f_{i2}=-f_{k1}`, and :math:`f_{j2}=-f_{k2}`. As in this pair style the +forces are read in directly, a correct MD simulation is also performed in the case that +the triplet energies are set to e=0. + +The *filename* specifies the file containing the tabulated energy and +derivative values of :math:`\phi_3 (r_{ij}, r_{ik}, \theta_{ijk})`. +The *keyword* then specifies a section of the file. The +format of this file is as follows (without the +parenthesized comments): + +.. parsed-literal:: + + # Tabulated three-body potential for spce water (one or more comment or blank lines) + + ENTRY1 (keyword is the first text on line) + N 12 rmin 2.55 rmax 3.65 (N, rmin, rmax parameters) + (blank line) + 1 2.55 2.55 3.75 -867.212 -611.273 867.212 21386.8 611.273 -21386.8 0.0 (index, r_ij, r_ik, theta, f_i1, f_i2, f_j1, f_j2, f_k1, f_k2, e) + 2 2.55 2.55 11.25 -621.539 -411.189 621.539 5035.95 411.189 -5035.95 0.0 + ... + 1872 3.65 3.65 176.25 -0.00215132 -0.00412886 0.00215137 0.00111754 0.00412895 -0.00111757 0.0 + +A section begins with a non-blank line whose first character is not a +"#"; blank lines or lines starting with "#" can be used as comments +between sections. The first line begins with a keyword which +identifies the section. The next line lists (in any +order) one or more parameters for the table. Each parameter is a +keyword followed by one or more numeric values. + +The parameter "N" is required. It should be the same than the parameter "N" of the ".3b" file, +otherwise its value is overwritten. "N" determines the number of table +entries "M" that follow: "M = N * N * (N+1)" (symmetric triplet, e.g. SiCC) or +"M = 2 * N * N * N" (asymmetric triplet, e.g. SiCSi). Therefore "M = 12 * 12 * 13 = 1872" +in the above symmetric example. The parameters "rmin" and "rmax" are also required +and determine the minimum and maximum of the inter-particle distances +:math:`r_{ij}` and :math:`r_{ik}`. + +Following a blank line, the next M lines of the angular table file list the tabulated values. +On each line, the first value is the index from 1 to M, the second value is the distance +:math:`r_{ij}`, the third value is the distance :math:`r_{ik}`, the fourth value +is the angle :math:`\theta_{ijk})`, the next six values are the force constants :math:`f_{i1}`, +:math:`f_{i2}`, :math:`f_{j1}`, :math:`f_{j2}`, :math:`f_{k1}`, and :math:`f_{k2}`, and the +last value is the energy e. + +Note that one three-body potential file can contain many sections, each with a tabulated +potential. LAMMPS reads the file section by section until it finds +one that matches the specified *keyword* of appropriate section of the ".3b" file. + +At the moment, only the *style* *linear* is allowed and implemented. After reading in the +force table, it is internally stored in LAMMPS as a lookup table. For each triplet +configuration occuring in the simulation within the cutoff distance, +the next nearest tabulated triplet configuration is looked up. No interpolation is done. +This allows for a very efficient force calculation +with the stored force constants and energies. Due to the know table structure, the lookup +can be done efficiently. It has been tested (:ref:`Scherer2 `) that with a reasonably +small bin size, the accuracy and speed is comparable to that of a Stillinger-Weber potential +with tabulated three-body interactions (:doc:`pair_style sw/table `) while +the table format of this pair style allows for more flexible three-body interactions. + +As for the Stillinger-Weber potential, the three-body potential file must contain entries for all the +elements listed in the pair_coeff command. It can also contain +entries for additional elements not being used in a particular +simulation; LAMMPS ignores those entries. + +For a single-element simulation, only a single entry is required +(e.g. SiSiSi). For a two-element simulation, the file must contain 8 +entries (for SiSiSi, SiSiC, SiCSi, SiCC, CSiSi, CSiC, CCSi, CCC), that +specify 3b parameters for all permutations of the two elements +interacting in three-body configurations. Thus for 3 elements, 27 +entries would be required, etc. + +As annotated above, the first element in the entry is the center atom +in a three-body interaction. Thus an entry for SiCC means a Si atom +with 2 C atoms as neighbors. The tabulated three-body forces can in +principle be specific to the three elements of the configuration. +However, the user must ensure that it makes physically sense. +E.g., the tabulated three-body forces for the +entries CSiC and CCSi should be the same exchanging :math:`r_{ij}` with +r_{ik}, :math:`f_{j1}` with :math:`f_{k1}`, +and :math:`f_{j2}` with :math:`f_{k2}`. + + +---------- + +Mixing, shift, table, tail correction, restart, rRESPA info +""""""""""""""""""""""""""""""""""""""""""""""""""""""""""" + +As all interactions are tabulated, no mixing is performed. + +This pair style does not support the :doc:`pair_modify ` +shift, table, and tail options. + +This pair style does not write its information to :doc:`binary restart files `, since it is stored in potential files. +Thus, you need to re-specify the pair_style and pair_coeff commands in an input +script that reads a restart file. + +This pair style can only be used via the *pair* keyword of the +:doc:`run_style respa ` command. It does not support the +*inner*, *middle*, *outer* keywords. + +---------- + +Restrictions +"""""""""""" + +This is a user pair style. For more information, see :ref:`Scherer2 `. It is only enabled +if LAMMPS was explicitly built with it. + +This pair style requires the :doc:`newton ` setting to be "on" +for pair interactions. + +For an example of a three-body potential file, have a look at the tutorial +in the tutorial folder. + +Related commands +"""""""""""""""" + +:doc:`pair_coeff ` + + +---------- + +.. _Scherer2: + +**(Scherer2)** C. Scherer, R. Scheid, D. Andrienko, and T. Bereau, J. Chem. Theor. Comp. 16, 3194–3204 (2020). + From 18c9960db033fb24e035b80ef7c090614be4c82f Mon Sep 17 00:00:00 2001 From: Christoph Scherer Date: Thu, 26 May 2022 14:25:24 +0200 Subject: [PATCH 218/585] examples/pair_sw_3b_table/README: minor correction --- examples/PACKAGES/pair_sw_3b_table/README | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/examples/PACKAGES/pair_sw_3b_table/README b/examples/PACKAGES/pair_sw_3b_table/README index 9d158bf392..690adbc30a 100644 --- a/examples/PACKAGES/pair_sw_3b_table/README +++ b/examples/PACKAGES/pair_sw_3b_table/README @@ -4,7 +4,7 @@ Example for pair style sw/table This example contains all required input files for the simulation of CG SPC/E water with the user pair style sw/table, as well as a run.sh script. -To run the example, you have to compile LAMMPS with the MANYBODY package, including pair_sw_3b_table.h and pair_sw_3b_table.h. +To run the example, you have to compile LAMMPS with the MANYBODY package, including pair_sw_3b_table.h and pair_sw_3b_table.cpp. Running the simulation, you will reproduce results of the following publication: From b8dfb23ede3dd7f781264baec0b902c99baa24e2 Mon Sep 17 00:00:00 2001 From: Christoph Scherer Date: Thu, 26 May 2022 14:32:12 +0200 Subject: [PATCH 219/585] examples/PACKAGES/pair_sw_3b_table/README: corrections in the text --- examples/PACKAGES/pair_sw_3b_table/README | 29 +++++++++++------------ 1 file changed, 14 insertions(+), 15 deletions(-) diff --git a/examples/PACKAGES/pair_sw_3b_table/README b/examples/PACKAGES/pair_sw_3b_table/README index 690adbc30a..2d00030fea 100644 --- a/examples/PACKAGES/pair_sw_3b_table/README +++ b/examples/PACKAGES/pair_sw_3b_table/README @@ -1,8 +1,8 @@ -Example for pair style sw/table -================================ +Example for pair style sw/3b/table + This example contains all required input files for the simulation of CG SPC/E water with -the user pair style sw/table, as well as a run.sh script. +the user pair style sw/3b/table, as well as a run.sh script. To run the example, you have to compile LAMMPS with the MANYBODY package, including pair_sw_3b_table.h and pair_sw_3b_table.cpp. @@ -10,10 +10,10 @@ Running the simulation, you will reproduce results of the following publication: C. Scherer, and D. Andrienko, Understanding three-body contributions to coarse-grained force fields, Phys. Chem. Chem. Phys, 20(34):22387–22394, 2018, http://xlink.rsc.org/?DOI=C8CP00746B -Here, a water molecule is represented by one coarse-grained (CG) bead. The -two-body (table_CG_CG.txt) and three-body angular (table_CG_CG_CG.txt) interaction potentials -have been parametrized with force-matching (FM) with the VOTCA package (https://gitlab.mpcdf.mpg.de/votca/votca). -For more details, have a look at the publication. For a example on the parametrization, have a look at +Here, a water molecule is represented by one coarse-grained (CG) bead. +The two-body (table_CG_CG.txt) and three-body angular (table_CG_CG_CG.txt) interaction potentials have been parametrized with force-matching (FM) with the VOTCA package (https://gitlab.mpcdf.mpg.de/votca/votca). +For more details, have a look at the publication. +For a example on the parametrization, have a look at https://gitlab.mpcdf.mpg.de/votca/votca/-/tree/master/csg-examples/guide and https://gitlab.mpcdf.mpg.de/votca/votca/-/tree/master/csg-examples/spce/3body_sw. @@ -22,20 +22,19 @@ of 1000 CG water molecules, an input file (spce.in) and a (modified) Stillinger- The lammps input file contains the lines specifying the pair style and coefficients: -- pair_style hybrid/overlay table linear 1200 sw/3b/table - use a combination of pair_style table with 1200 linear table entries and the pair_style sw/3b/table +- pair_style hybrid/overlay table linear 1200 sw/3b/table - use a combination of pair style table with 1200 linear table entries and the pair style sw/3b/table - pair_coeff 1 1 table table_CG_CG.txt VOTCA - set the table name and keyword for the pair_style table -- pair_coeff * * sw/3b/table spce.sw type - set the name of the Stillinger-Weber file for the pair_style sw/3b/table +- pair_coeff * * sw/3b/table spce.sw type - set the name of the Stillinger-Weber file for the pair style sw/3b/table -A hybrid pair style is used, where pair forces are calculated as a tabulated interaction (table_CG_CG.txt) and the -pair style sw/table is only used to calculate the three-body forces. Therefore, in the Stillinger-Weber file all -parameters refering to two-body interactions are set to zero. As explained in the documentation of this pair -style, the .sw file contains the -additional lines refering to the tabulated angular potential: +A hybrid pair style is used, where pair forces are calculated as a tabulated interaction (table_CG_CG.txt) and the pair style sw/3b/table is only used to calculate the three-body forces. +Therefore, in the Stillinger-Weber file all parameters refering to two-body interactions are set to zero. +As explained in the documentation of this pair style, the .sw file contains the additional lines refering to the tabulated angular potential: - table_CG_CG_CG.txt - file name of tabulated angular potential - VOTCA - keyword for tabulated angular potential - linear - angular table is of linear style - 1001 - 1001 table entries -The LAMMPS simulation is a standard nvt simulation. A dump file is output with the positions and forces every 10 time steps. +The LAMMPS simulation is a standard nvt simulation. +A dump file is output with the positions and forces every 10 time steps. You can calculate the pair distribution and compare it to the one(s) in the publicattion. From e890e5718e9a980fa7013d5ad2d0881836aae960 Mon Sep 17 00:00:00 2001 From: Christoph Scherer Date: Thu, 26 May 2022 14:45:22 +0200 Subject: [PATCH 220/585] examples/PACKAGES/pair_3b_table: added example for new pair style 3b/table --- examples/PACKAGES/pair_3b_table/1-1-1.table | 1875 +++++++++ examples/PACKAGES/pair_3b_table/1-1-2.table | 3459 +++++++++++++++++ .../PACKAGES/pair_3b_table/CG-CG-CG.dist.new | 63 + .../PACKAGES/pair_3b_table/CG-CG.dist.new | 301 ++ examples/PACKAGES/pair_3b_table/README | 65 + .../pair_3b_table/calculate_distributions.xml | 29 + examples/PACKAGES/pair_3b_table/run.sh | 8 + examples/PACKAGES/pair_3b_table/spce.3b | 8 + examples/PACKAGES/pair_3b_table/spce.data | 1015 +++++ examples/PACKAGES/pair_3b_table/spce.in | 43 + examples/PACKAGES/pair_3b_table/spce_2.3b | 71 + examples/PACKAGES/pair_3b_table/spce_2.data | 1016 +++++ examples/PACKAGES/pair_3b_table/spce_2.in | 43 + .../PACKAGES/pair_3b_table/table_CG_CG.txt | 1203 ++++++ 14 files changed, 9199 insertions(+) create mode 100644 examples/PACKAGES/pair_3b_table/1-1-1.table create mode 100644 examples/PACKAGES/pair_3b_table/1-1-2.table create mode 100644 examples/PACKAGES/pair_3b_table/CG-CG-CG.dist.new create mode 100644 examples/PACKAGES/pair_3b_table/CG-CG.dist.new create mode 100644 examples/PACKAGES/pair_3b_table/README create mode 100644 examples/PACKAGES/pair_3b_table/calculate_distributions.xml create mode 100755 examples/PACKAGES/pair_3b_table/run.sh create mode 100644 examples/PACKAGES/pair_3b_table/spce.3b create mode 100644 examples/PACKAGES/pair_3b_table/spce.data create mode 100644 examples/PACKAGES/pair_3b_table/spce.in create mode 100644 examples/PACKAGES/pair_3b_table/spce_2.3b create mode 100644 examples/PACKAGES/pair_3b_table/spce_2.data create mode 100644 examples/PACKAGES/pair_3b_table/spce_2.in create mode 100644 examples/PACKAGES/pair_3b_table/table_CG_CG.txt diff --git a/examples/PACKAGES/pair_3b_table/1-1-1.table b/examples/PACKAGES/pair_3b_table/1-1-1.table new file mode 100644 index 0000000000..76d8f8a9ec --- /dev/null +++ b/examples/PACKAGES/pair_3b_table/1-1-1.table @@ -0,0 +1,1875 @@ +ENTRY1 +N 12 rmin 2.55 rmax 3.65 + +1 2.55 2.55 3.75 -867.212 -611.273 867.212 21386.8 611.273 -21386.8 0.0 +2 2.55 2.55 11.25 -621.539 -411.189 621.539 5035.95 411.189 -5035.95 0.0 +3 2.55 2.55 18.75 -394.167 -243.287 394.167 1722.21 243.287 -1722.21 0.0 +4 2.55 2.55 26.25 -218.789 -127.402 218.789 560.206 127.402 -560.206 0.0 +5 2.55 2.55 33.75 -104.252 -59.5774 104.252 156.639 59.5774 -156.639 0.0 +6 2.55 2.55 41.25 -41.0722 -24.6716 41.072 36.4446 24.6716 -36.4446 0.0 +7 2.55 2.55 48.75 -12.357 -8.38061 12.3571 7.1117 8.38062 -7.1117 0.0 +8 2.55 2.55 56.25 -2.29912 -1.68047 2.29907 0.91657 1.68048 -0.916568 0.0 +9 2.55 2.55 63.75 -0.0509977 0.327321 0.0509129 -0.304729 -0.327319 0.30474 0.0 +10 2.55 2.55 71.25 0.0345509 0.431792 -0.0345867 -0.382614 -0.431782 0.382616 0.0 +11 2.55 2.55 78.75 -0.00019898 0.179593 0.000319523 -0.292658 -0.179608 0.292661 0.0 +12 2.55 2.55 86.25 0.154169 0.138217 -0.154088 -0.302917 -0.138224 0.302914 0.0 +13 2.55 2.55 93.75 0.327691 0.263922 -0.327675 -0.340147 -0.263894 0.340148 0.0 +14 2.55 2.55 101.25 0.382895 0.350591 -0.382883 -0.297308 -0.350546 0.297312 0.0 +15 2.55 2.55 108.75 0.300955 0.297417 -0.300746 -0.173862 -0.297437 0.173872 0.0 +16 2.55 2.55 116.25 0.138507 0.141879 -0.138328 -0.0349372 -0.1418 0.0349415 0.0 +17 2.55 2.55 123.75 -0.0287949 -0.0286834 0.0286744 0.065848 0.0287665 -0.0658601 0.0 +18 2.55 2.55 131.25 -0.160323 -0.164235 0.160302 0.120341 0.164191 -0.120297 0.0 +19 2.55 2.55 138.75 -0.274013 -0.280673 0.274077 0.156939 0.280642 -0.156913 0.0 +20 2.55 2.55 146.25 -0.42361 -0.430992 0.423711 0.212433 0.430824 -0.212358 0.0 +21 2.55 2.55 153.75 -0.648177 -0.651719 0.648516 0.305821 0.651726 -0.305791 0.0 +22 2.55 2.55 161.25 -0.93181 -0.926724 0.931895 0.426805 0.926702 -0.426778 0.0 +23 2.55 2.55 168.75 -1.20276 -1.18735 1.20273 0.541966 1.18745 -0.542019 0.0 +24 2.55 2.55 176.25 -1.36933 -1.34705 1.3691 0.612284 1.34703 -0.612297 0.0 +25 2.55 2.65 3.75 -784.444 -675.519 784.444 19696.9 675.519 -19696.9 0.0 +26 2.55 2.65 11.25 -542.941 -440.852 542.941 5300.59 440.852 -5300.59 0.0 +27 2.55 2.65 18.75 -325.839 -241.234 325.839 1817.37 241.234 -1817.37 0.0 +28 2.55 2.65 26.25 -169.421 -111.015 169.421 580.214 111.015 -580.214 0.0 +29 2.55 2.65 33.75 -74.994 -43.3669 74.994 155.496 43.3669 -155.496 0.0 +30 2.55 2.65 41.25 -27.0736 -14.8824 27.0736 33.1152 14.8824 -33.1152 0.0 +31 2.55 2.65 48.75 -7.12613 -4.62454 7.12621 5.36809 4.62453 -5.36811 0.0 +32 2.55 2.65 56.25 -0.874199 -1.13723 0.874234 0.34195 1.13723 -0.341919 0.0 +33 2.55 2.65 63.75 0.204812 -0.0406907 -0.204883 -0.442652 0.0407084 0.442642 0.0 +34 2.55 2.65 71.25 0.0904568 0.154881 -0.0905494 -0.435451 -0.154894 0.435459 0.0 +35 2.55 2.65 78.75 0.0458835 0.126591 -0.0460614 -0.333955 -0.126573 0.33396 0.0 +36 2.55 2.65 86.25 0.168148 0.163197 -0.168343 -0.309845 -0.163197 0.309848 0.0 +37 2.55 2.65 93.75 0.296449 0.261093 -0.296361 -0.307947 -0.261084 0.307954 0.0 +38 2.55 2.65 101.25 0.329963 0.311331 -0.329831 -0.254571 -0.311318 0.254565 0.0 +39 2.55 2.65 108.75 0.253841 0.255391 -0.253789 -0.146686 -0.255437 0.146721 0.0 +40 2.55 2.65 116.25 0.107857 0.119105 -0.107492 -0.0254819 -0.119136 0.0254837 0.0 +41 2.55 2.65 123.75 -0.0492191 -0.0344023 0.0490594 0.0707149 0.0343792 -0.0707119 0.0 +42 2.55 2.65 131.25 -0.180513 -0.166858 0.180388 0.1322 0.16692 -0.132248 0.0 +43 2.55 2.65 138.75 -0.300448 -0.291041 0.300451 0.178321 0.291015 -0.178345 0.0 +44 2.55 2.65 146.25 -0.45666 -0.451363 0.456715 0.239144 0.451427 -0.239145 0.0 +45 2.55 2.65 153.75 -0.684349 -0.67857 0.684481 0.332093 0.678651 -0.332112 0.0 +46 2.55 2.65 161.25 -0.966732 -0.954719 0.966651 0.448833 0.954615 -0.448783 0.0 +47 2.55 2.65 168.75 -1.23353 -1.21297 1.23383 0.558954 1.21297 -0.558949 0.0 +48 2.55 2.65 176.25 -1.39695 -1.37031 1.39698 0.626037 1.37022 -0.625967 0.0 +49 2.55 2.75 3.75 -668.413 -701.057 668.413 15096.3 701.057 -15096.3 0.0 +50 2.55 2.75 11.25 -452.8 -464.411 452.8 5130.32 464.411 -5130.32 0.0 +51 2.55 2.75 18.75 -256.012 -246.87 256.012 1797.07 246.87 -1797.07 0.0 +52 2.55 2.75 26.25 -123.333 -105.643 123.333 565.052 105.643 -565.052 0.0 +53 2.55 2.75 33.75 -50.2709 -35.7913 50.2709 144.93 35.7913 -144.93 0.0 +54 2.55 2.75 41.25 -16.78 -9.69921 16.78 28.1038 9.69923 -28.1038 0.0 +55 2.55 2.75 48.75 -4.12155 -2.37411 4.12164 3.76214 2.3741 -3.76217 0.0 +56 2.55 2.75 56.25 -0.484016 -0.658362 0.484128 0.146857 0.658338 -0.146846 0.0 +57 2.55 2.75 63.75 0.0687647 -0.20106 -0.0687734 -0.260534 0.20103 0.260497 0.0 +58 2.55 2.75 71.25 -0.00147066 -0.0603687 0.0015277 -0.268714 0.0604159 0.268722 0.0 +59 2.55 2.75 78.75 0.0156999 0.0125791 -0.0159656 -0.252993 -0.0125614 0.252974 0.0 +60 2.55 2.75 86.25 0.136925 0.119249 -0.13684 -0.269725 -0.11924 0.269725 0.0 +61 2.55 2.75 93.75 0.247327 0.234358 -0.247334 -0.272826 -0.234332 0.272827 0.0 +62 2.55 2.75 101.25 0.281753 0.286511 -0.281826 -0.224691 -0.286549 0.224691 0.0 +63 2.55 2.75 108.75 0.226138 0.242659 -0.226349 -0.131815 -0.24272 0.131841 0.0 +64 2.55 2.75 116.25 0.106433 0.12752 -0.10664 -0.0258695 -0.127594 0.0258609 0.0 +65 2.55 2.75 123.75 -0.0277616 -0.00630627 0.0276778 0.0615222 0.00630865 -0.0614969 0.0 +66 2.55 2.75 131.25 -0.142446 -0.124893 0.142414 0.118979 0.124975 -0.11903 0.0 +67 2.55 2.75 138.75 -0.248783 -0.237903 0.248779 0.161562 0.237995 -0.161575 0.0 +68 2.55 2.75 146.25 -0.392668 -0.385233 0.392627 0.216964 0.385134 -0.21689 0.0 +69 2.55 2.75 153.75 -0.606858 -0.595071 0.606818 0.302592 0.595088 -0.302606 0.0 +70 2.55 2.75 161.25 -0.874793 -0.851019 0.874799 0.411383 0.850969 -0.411357 0.0 +71 2.55 2.75 168.75 -1.12893 -1.0911 1.12904 0.514712 1.09102 -0.514675 0.0 +72 2.55 2.75 176.25 -1.28457 -1.23755 1.28455 0.577854 1.23747 -0.577828 0.0 +73 2.55 2.85 3.75 -540.757 -671.949 540.757 11232.9 671.949 -11232.9 0.0 +74 2.55 2.85 11.25 -358.962 -456.955 358.962 4626.32 456.955 -4626.32 0.0 +75 2.55 2.85 18.75 -189.205 -242.387 189.205 1670.73 242.387 -1670.73 0.0 +76 2.55 2.85 26.25 -82.3789 -101.034 82.3789 518.217 101.034 -518.217 0.0 +77 2.55 2.85 33.75 -30.0098 -32.1026 30.0098 126.998 32.1025 -126.998 0.0 +78 2.55 2.85 41.25 -9.21751 -7.56922 9.21749 22.2838 7.5692 -22.2838 0.0 +79 2.55 2.85 48.75 -2.28489 -1.50529 2.28485 2.35574 1.50529 -2.35573 0.0 +80 2.55 2.85 56.25 -0.358049 -0.489852 0.357948 0.0188984 0.489874 -0.0189109 0.0 +81 2.55 2.85 63.75 -0.00522043 -0.307792 0.00494878 -0.134592 0.307776 0.134574 0.0 +82 2.55 2.85 71.25 0.00323495 -0.2024 -0.00313048 -0.169997 0.202387 0.169981 0.0 +83 2.55 2.85 78.75 0.0415278 -0.0778296 -0.0414056 -0.213315 0.077898 0.213326 0.0 +84 2.55 2.85 86.25 0.131889 0.069504 -0.132199 -0.248098 -0.0695577 0.248098 0.0 +85 2.55 2.85 93.75 0.214594 0.193542 -0.214655 -0.244475 -0.193398 0.244477 0.0 +86 2.55 2.85 101.25 0.244494 0.247624 -0.244635 -0.195685 -0.247697 0.195696 0.0 +87 2.55 2.85 108.75 0.201434 0.218545 -0.201617 -0.114828 -0.218615 0.114846 0.0 +88 2.55 2.85 116.25 0.0998591 0.127904 -0.0997024 -0.024899 -0.127956 0.0249269 0.0 +89 2.55 2.85 123.75 -0.0181479 0.0163555 0.0181766 0.049407 -0.0163067 -0.0494209 0.0 +90 2.55 2.85 131.25 -0.11898 -0.0876934 0.119352 0.098005 0.0875449 -0.0979311 0.0 +91 2.55 2.85 138.75 -0.214707 -0.191866 0.214605 0.134596 0.191898 -0.13457 0.0 +92 2.55 2.85 146.25 -0.347993 -0.330815 0.348041 0.185048 0.330869 -0.185107 0.0 +93 2.55 2.85 153.75 -0.550177 -0.528952 0.549981 0.265291 0.528797 -0.265232 0.0 +94 2.55 2.85 161.25 -0.804311 -0.769737 0.804194 0.367848 0.769696 -0.367861 0.0 +95 2.55 2.85 168.75 -1.04529 -0.994652 1.04554 0.465186 0.99499 -0.465282 0.0 +96 2.55 2.85 176.25 -1.19281 -1.13166 1.19305 0.52457 1.13177 -0.524594 0.0 +97 2.55 2.95 3.75 -419.502 -582.296 419.502 8332.23 582.296 -8332.23 0.0 +98 2.55 2.95 11.25 -271.55 -404.417 271.55 3930.48 404.417 -3930.48 0.0 +99 2.55 2.95 18.75 -130.928 -214.969 130.928 1464.2 214.969 -1464.2 0.0 +100 2.55 2.95 26.25 -48.786 -88.4342 48.786 447.646 88.4342 -447.646 0.0 +101 2.55 2.95 33.75 -14.3964 -27.3665 14.3964 104.519 27.3665 -104.519 0.0 +102 2.55 2.95 41.25 -3.7883 -6.20808 3.78827 16.4944 6.20806 -16.4944 0.0 +103 2.55 2.95 48.75 -1.0529 -1.19869 1.05292 1.27167 1.19863 -1.27161 0.0 +104 2.55 2.95 56.25 -0.231522 -0.429682 0.231513 -0.0951674 0.429629 0.0951268 0.0 +105 2.55 2.95 63.75 0.0181127 -0.325032 -0.0180919 -0.110423 0.324922 0.110426 0.0 +106 2.55 2.95 71.25 0.049094 -0.246096 -0.0491496 -0.144969 0.245996 0.14495 0.0 +107 2.55 2.95 78.75 0.063364 -0.114463 -0.0633467 -0.196803 0.114426 0.196797 0.0 +108 2.55 2.95 86.25 0.11583 0.0385036 -0.115786 -0.223948 -0.0384687 0.223952 0.0 +109 2.55 2.95 93.75 0.177943 0.156855 -0.178064 -0.209887 -0.156845 0.209889 0.0 +110 2.55 2.95 101.25 0.207654 0.212381 -0.207593 -0.163549 -0.212444 0.163567 0.0 +111 2.55 2.95 108.75 0.175031 0.201414 -0.174609 -0.0967898 -0.20124 0.0967398 0.0 +112 2.55 2.95 116.25 0.0862557 0.136066 -0.0862066 -0.0233966 -0.13596 0.0233258 0.0 +113 2.55 2.95 123.75 -0.0191239 0.0441682 0.0193287 0.0382847 -0.0441811 -0.0382953 0.0 +114 2.55 2.95 131.25 -0.110069 -0.050979 0.109801 0.0798251 0.0509319 -0.0799025 0.0 +115 2.55 2.95 138.75 -0.196213 -0.153394 0.196102 0.113373 0.153405 -0.113396 0.0 +116 2.55 2.95 146.25 -0.318885 -0.291367 0.319145 0.161467 0.291373 -0.161505 0.0 +117 2.55 2.95 153.75 -0.50686 -0.483737 0.506732 0.236963 0.48342 -0.236818 0.0 +118 2.55 2.95 161.25 -0.742764 -0.712982 0.742837 0.331712 0.713077 -0.331758 0.0 +119 2.55 2.95 168.75 -0.965814 -0.924655 0.965837 0.420445 0.924729 -0.420487 0.0 +120 2.55 2.95 176.25 -1.10185 -1.05258 1.10198 0.474136 1.05241 -0.474051 0.0 +121 2.55 3.05 3.75 -319.111 -440.938 319.111 6126.66 440.938 -6126.66 0.0 +122 2.55 3.05 11.25 -200.795 -309.049 200.795 3169.23 309.049 -3169.23 0.0 +123 2.55 3.05 18.75 -86.7152 -162.683 86.7152 1211.49 162.683 -1211.49 0.0 +124 2.55 3.05 26.25 -24.7922 -65.0953 24.7921 363.733 65.0953 -363.733 0.0 +125 2.55 3.05 33.75 -3.79557 -19.4403 3.79568 80.4622 19.4403 -80.4622 0.0 +126 2.55 3.05 41.25 -0.227488 -4.40816 0.227381 11.3442 4.40812 -11.3442 0.0 +127 2.55 3.05 48.75 -0.215962 -0.9846 0.21623 0.572809 0.984607 -0.572833 0.0 +128 2.55 3.05 56.25 -0.0972827 -0.406271 0.0971886 -0.155442 0.406388 0.155438 0.0 +129 2.55 3.05 63.75 0.0474691 -0.320721 -0.0473142 -0.115525 0.320742 0.115541 0.0 +130 2.55 3.05 71.25 0.0542543 -0.274312 -0.0545515 -0.127569 0.274174 0.127517 0.0 +131 2.55 3.05 78.75 0.0439985 -0.158092 -0.0440511 -0.165185 0.158055 0.165194 0.0 +132 2.55 3.05 86.25 0.0821507 -0.00877884 -0.0821081 -0.183829 0.00887135 0.183832 0.0 +133 2.55 3.05 93.75 0.142245 0.109192 -0.142406 -0.168613 -0.109223 0.168609 0.0 +134 2.55 3.05 101.25 0.176786 0.175042 -0.176859 -0.131259 -0.174989 0.13127 0.0 +135 2.55 3.05 108.75 0.153044 0.185839 -0.153188 -0.0796497 -0.185913 0.0796723 0.0 +136 2.55 3.05 116.25 0.0762661 0.144574 -0.0760233 -0.0213083 -0.14475 0.0213947 0.0 +137 2.55 3.05 123.75 -0.0153973 0.0697421 0.0151775 0.0294442 -0.0697414 -0.0295136 0.0 +138 2.55 3.05 131.25 -0.0914496 -0.0164558 0.0915457 0.0650391 0.01638 -0.0650155 0.0 +139 2.55 3.05 138.75 -0.163525 -0.114278 0.163505 0.0952572 0.113968 -0.0951433 0.0 +140 2.55 3.05 146.25 -0.267879 -0.245016 0.267903 0.138326 0.244925 -0.138338 0.0 +141 2.55 3.05 153.75 -0.430018 -0.423265 0.429956 0.203867 0.423326 -0.203942 0.0 +142 2.55 3.05 161.25 -0.633833 -0.631774 0.634037 0.284186 0.631568 -0.284063 0.0 +143 2.55 3.05 168.75 -0.826685 -0.82183 0.826375 0.358252 0.82172 -0.358225 0.0 +144 2.55 3.05 176.25 -0.943422 -0.93572 0.943723 0.402697 0.935847 -0.402743 0.0 +145 2.55 3.15 3.75 -249.767 -271.418 249.767 4425.44 271.418 -4425.44 0.0 +146 2.55 3.15 11.25 -154.5 -187.982 154.5 2434.18 187.982 -2434.18 0.0 +147 2.55 3.15 18.75 -60.5981 -94.4639 60.5982 946.499 94.4639 -946.499 0.0 +148 2.55 3.15 26.25 -11.8534 -34.6155 11.8535 277.025 34.6156 -277.025 0.0 +149 2.55 3.15 33.75 1.6123 -9.2646 -1.61231 57.3974 9.26465 -57.3974 0.0 +150 2.55 3.15 41.25 1.60158 -2.19805 -1.60158 7.12692 2.19808 -7.12698 0.0 +151 2.55 3.15 48.75 0.26948 -0.778894 -0.269488 0.21063 0.778852 -0.210617 0.0 +152 2.55 3.15 56.25 -0.01372 -0.412911 0.0136807 -0.142081 0.412893 0.142164 0.0 +153 2.55 3.15 63.75 0.0224038 -0.329718 -0.0222862 -0.0965871 0.329602 0.096574 0.0 +154 2.55 3.15 71.25 0.0060749 -0.316094 -0.00598008 -0.0883032 0.316076 0.0883122 0.0 +155 2.55 3.15 78.75 0.00302628 -0.219142 -0.00292645 -0.117193 0.219165 0.117188 0.0 +156 2.55 3.15 86.25 0.0523024 -0.0705546 -0.0522252 -0.136651 0.0705734 0.136649 0.0 +157 2.55 3.15 93.75 0.115651 0.0544573 -0.11564 -0.126319 -0.0545821 0.126326 0.0 +158 2.55 3.15 101.25 0.148969 0.134261 -0.149041 -0.0986894 -0.134289 0.0986837 0.0 +159 2.55 3.15 108.75 0.128464 0.165022 -0.12849 -0.0608071 -0.165301 0.0608822 0.0 +160 2.55 3.15 116.25 0.0654112 0.144738 -0.0648575 -0.0171687 -0.144771 0.0172192 0.0 +161 2.55 3.15 123.75 -0.00700089 0.0874701 0.0070514 0.0212287 -0.087399 -0.0213181 0.0 +162 2.55 3.15 131.25 -0.0630668 0.0158432 0.0629726 0.0481408 -0.0158028 -0.0482207 0.0 +163 2.55 3.15 138.75 -0.113207 -0.0669731 0.112947 0.0710475 0.0668196 -0.0709779 0.0 +164 2.55 3.15 146.25 -0.189616 -0.177294 0.189595 0.103802 0.177145 -0.103761 0.0 +165 2.55 3.15 153.75 -0.313405 -0.326317 0.313385 0.153359 0.326249 -0.1534 0.0 +166 2.55 3.15 161.25 -0.471349 -0.499401 0.471384 0.2136 0.499615 -0.213641 0.0 +167 2.55 3.15 168.75 -0.621738 -0.656501 0.621526 0.268765 0.656234 -0.268609 0.0 +168 2.55 3.15 176.25 -0.713168 -0.750131 0.713075 0.301728 0.749961 -0.301587 0.0 +169 2.55 3.25 3.75 -215.533 -105.036 215.533 3115.64 105.036 -3115.64 0.0 +170 2.55 3.25 11.25 -135.709 -66.1673 135.709 1782.43 66.1673 -1782.43 0.0 +171 2.55 3.25 18.75 -53.5226 -25.2778 53.5226 697.12 25.2777 -697.12 0.0 +172 2.55 3.25 26.25 -9.76548 -4.05586 9.76548 196.405 4.05587 -196.405 0.0 +173 2.55 3.25 33.75 2.26986 0.661867 -2.26987 37.2172 -0.661895 -37.2172 0.0 +174 2.55 3.25 41.25 1.94008 -0.139655 -1.94016 3.90169 0.139693 -3.90171 0.0 +175 2.55 3.25 48.75 0.433581 -0.598298 -0.433653 0.0713369 0.598313 -0.071257 0.0 +176 2.55 3.25 56.25 -0.0110448 -0.396733 0.0111185 -0.0792235 0.396666 0.0791487 0.0 +177 2.55 3.25 63.75 -0.0512665 -0.306617 0.0511183 -0.0540821 0.306458 0.05412 0.0 +178 2.55 3.25 71.25 -0.0567327 -0.327807 0.0568023 -0.042547 0.327783 0.0424758 0.0 +179 2.55 3.25 78.75 -0.0248985 -0.256832 0.0248957 -0.0738229 0.256924 0.073814 0.0 +180 2.55 3.25 86.25 0.03699 -0.115693 -0.0368212 -0.0949395 0.115771 0.0949412 0.0 +181 2.55 3.25 93.75 0.088578 0.0114051 -0.0885974 -0.0851166 -0.0114329 0.0851098 0.0 +182 2.55 3.25 101.25 0.108379 0.100211 -0.108454 -0.0631833 -0.100386 0.0632103 0.0 +183 2.55 3.25 108.75 0.0905494 0.146067 -0.0902676 -0.0380134 -0.146103 0.0380456 0.0 +184 2.55 3.25 116.25 0.0446648 0.143011 -0.0447651 -0.0105656 -0.143148 0.0105849 0.0 +185 2.55 3.25 123.75 -0.00397982 0.102972 0.00398606 0.0132778 -0.103051 -0.0132872 0.0 +186 2.55 3.25 131.25 -0.0396488 0.0470538 0.0395149 0.0295482 -0.0468879 -0.0296284 0.0 +187 2.55 3.25 138.75 -0.0696427 -0.0184498 0.0696581 0.0434558 0.0182276 -0.0433637 0.0 +188 2.55 3.25 146.25 -0.118295 -0.104198 0.11835 0.0645889 0.104105 -0.0645169 0.0 +189 2.55 3.25 153.75 -0.201226 -0.219646 0.201381 0.0977209 0.219776 -0.0977906 0.0 +190 2.55 3.25 161.25 -0.310278 -0.35328 0.310501 0.138558 0.353454 -0.138633 0.0 +191 2.55 3.25 168.75 -0.415467 -0.474235 0.415053 0.176198 0.474086 -0.176145 0.0 +192 2.55 3.25 176.25 -0.479006 -0.546119 0.479273 0.198749 0.546279 -0.198787 0.0 +193 2.55 3.35 3.75 -204.898 28.1648 204.898 2043.28 -28.1648 -2043.28 0.0 +194 2.55 3.35 11.25 -135.949 31.6213 135.949 1195.68 -31.6213 -1195.68 0.0 +195 2.55 3.35 18.75 -60.0294 29.3309 60.0294 464.081 -29.3309 -464.081 0.0 +196 2.55 3.35 26.25 -15.5602 19.1482 15.5602 123.342 -19.1482 -123.342 0.0 +197 2.55 3.35 33.75 -0.516502 7.80361 0.516464 20.3914 -7.80361 -20.3915 0.0 +198 2.55 3.35 41.25 1.1959 1.28099 -1.1959 1.61912 -1.28089 -1.61917 0.0 +199 2.55 3.35 48.75 0.338664 -0.427486 -0.338735 0.0672361 0.427458 -0.0671949 0.0 +200 2.55 3.35 56.25 -0.0712654 -0.32692 0.0713186 -0.00513307 0.326996 0.00515152 0.0 +201 2.55 3.35 63.75 -0.121975 -0.24598 0.122164 -0.0158901 0.24595 0.0159275 0.0 +202 2.55 3.35 71.25 -0.0836168 -0.3049 0.0833968 -0.0145822 0.304962 0.0145084 0.0 +203 2.55 3.35 78.75 -0.0227775 -0.26582 0.0226797 -0.0466388 0.265827 0.0466007 0.0 +204 2.55 3.35 86.25 0.0253278 -0.141365 -0.0252494 -0.0598516 0.14135 0.0598496 0.0 +205 2.55 3.35 93.75 0.0478277 -0.0194912 -0.0477364 -0.0442668 0.01948 0.0442715 0.0 +206 2.55 3.35 101.25 0.0542989 0.072706 -0.0542353 -0.0265114 -0.0727603 0.0265457 0.0 +207 2.55 3.35 108.75 0.0474436 0.128762 -0.0473722 -0.0142292 -0.128667 0.0141884 0.0 +208 2.55 3.35 116.25 0.024829 0.139676 -0.0246836 -0.00238193 -0.139623 0.00240878 0.0 +209 2.55 3.35 123.75 -0.00477975 0.112522 0.00457921 0.00880631 -0.112295 -0.00892129 0.0 +210 2.55 3.35 131.25 -0.0290626 0.0670303 0.0288612 0.0167144 -0.0668681 -0.0167711 0.0 +211 2.55 3.35 138.75 -0.0488435 0.012812 0.048558 0.0234532 -0.0126738 -0.0236424 0.0 +212 2.55 3.35 146.25 -0.0762617 -0.0554933 0.0763255 0.0346659 0.0553813 -0.0346319 0.0 +213 2.55 3.35 153.75 -0.123726 -0.144228 0.123766 0.053841 0.144227 -0.0538008 0.0 +214 2.55 3.35 161.25 -0.18791 -0.245407 0.187929 0.078822 0.245764 -0.079086 0.0 +215 2.55 3.35 168.75 -0.251038 -0.336304 0.251286 0.102654 0.336317 -0.102638 0.0 +216 2.55 3.35 176.25 -0.29084 -0.390314 0.290697 0.117217 0.390531 -0.11737 0.0 +217 2.55 3.45 3.75 -160.11 78.3904 160.11 964.746 -78.3904 -964.746 0.0 +218 2.55 3.45 11.25 -112.253 65.2155 112.253 569.896 -65.2155 -569.896 0.0 +219 2.55 3.45 18.75 -55.5875 44.2652 55.5876 216.275 -44.2652 -216.275 0.0 +220 2.55 3.45 26.25 -18.577 23.1948 18.5771 52.7785 -23.1948 -52.7785 0.0 +221 2.55 3.45 33.75 -3.3749 8.35207 3.37496 7.08855 -8.35205 -7.08857 0.0 +222 2.55 3.45 41.25 0.0558271 1.43995 -0.0557888 0.416872 -1.44003 -0.416798 0.0 +223 2.55 3.45 48.75 0.0736874 -0.250918 -0.0736577 0.137694 0.25083 -0.137688 0.0 +224 2.55 3.45 56.25 -0.118382 -0.234235 0.118498 0.029723 0.234224 -0.0297093 0.0 +225 2.55 3.45 63.75 -0.103993 -0.193692 0.103998 -0.0111831 0.193659 0.0111847 0.0 +226 2.55 3.45 71.25 -0.0373239 -0.248873 0.0374 -0.0103758 0.248904 0.0103568 0.0 +227 2.55 3.45 78.75 -0.000815577 -0.221711 0.000857674 -0.0239127 0.221702 0.0239331 0.0 +228 2.55 3.45 86.25 0.00235137 -0.12606 -0.00247045 -0.0235691 0.126024 0.0235785 0.0 +229 2.55 3.45 93.75 0.000693468 -0.0322758 -0.000731622 -0.0100368 0.0322426 0.0100472 0.0 +230 2.55 3.45 101.25 0.0107898 0.0378694 -0.0109773 -0.00230259 -0.0379779 0.00230944 0.0 +231 2.55 3.45 108.75 0.0223901 0.0828189 -0.0224924 -0.0011966 -0.0828617 0.00119886 0.0 +232 2.55 3.45 116.25 0.01901 0.0976112 -0.0189845 0.000576941 -0.0977212 -0.000592258 0.0 +233 2.55 3.45 123.75 0.0023177 0.0865526 -0.00220076 0.00381654 -0.0867258 -0.00376165 0.0 +234 2.55 3.45 131.25 -0.0137084 0.0618094 0.0137112 0.00514774 -0.0618168 -0.00513733 0.0 +235 2.55 3.45 138.75 -0.0208603 0.0307928 0.0209021 0.00395318 -0.0306512 -0.00401619 0.0 +236 2.55 3.45 146.25 -0.0246671 -0.00894626 0.0246851 0.00351226 0.00893543 -0.0035253 0.0 +237 2.55 3.45 153.75 -0.0354818 -0.0611658 0.0352745 0.0074458 0.0613979 -0.00758451 0.0 +238 2.55 3.45 161.25 -0.0568268 -0.12175 0.0568015 0.016221 0.121744 -0.0162267 0.0 +239 2.55 3.45 168.75 -0.0825887 -0.177017 0.0826212 0.0265372 0.177062 -0.0266112 0.0 +240 2.55 3.45 176.25 -0.100362 -0.210215 0.100363 0.0334528 0.210225 -0.0334721 0.0 +241 2.55 3.55 3.75 -78.9919 44.1593 78.9919 272.44 -44.1593 -272.44 0.0 +242 2.55 3.55 11.25 -57.4405 35.3664 57.4405 160.985 -35.3664 -160.985 0.0 +243 2.55 3.55 18.75 -30.4327 22.6574 30.4327 59.1789 -22.6574 -59.1789 0.0 +244 2.55 3.55 26.25 -11.3918 11.2259 11.3918 13.1796 -11.2259 -13.1796 0.0 +245 2.55 3.55 33.75 -2.72329 3.8781 2.7233 1.57893 -3.87813 -1.57891 0.0 +246 2.55 3.55 41.25 -0.349405 0.648596 0.349417 0.278163 -0.648614 -0.278143 0.0 +247 2.55 3.55 48.75 -0.0951034 -0.129698 0.0950942 0.144918 0.129704 -0.144907 0.0 +248 2.55 3.55 56.25 -0.0904303 -0.132617 0.0904025 -0.000622582 0.13263 0.000613981 0.0 +249 2.55 3.55 63.75 -0.0258623 -0.110734 0.0258374 -0.0284537 0.110749 0.0284432 0.0 +250 2.55 3.55 71.25 0.0130336 -0.121492 -0.0129784 -0.00958708 0.121519 0.0095864 0.0 +251 2.55 3.55 78.75 0.00216509 -0.0947175 -0.00212262 -0.00146876 0.0947229 0.0014866 0.0 +252 2.55 3.55 86.25 -0.0193046 -0.044118 0.0193305 0.000949206 0.0440946 -0.000951166 0.0 +253 2.55 3.55 93.75 -0.0204643 -0.00523306 0.0203838 0.00128217 0.00527308 -0.00128181 0.0 +254 2.55 3.55 101.25 -0.00377452 0.0162146 0.00374878 -0.00203826 -0.0161878 0.00203335 0.0 +255 2.55 3.55 108.75 0.0103855 0.0283922 -0.0103646 -0.00590355 -0.0284035 0.0059097 0.0 +256 2.55 3.55 116.25 0.0107496 0.0355757 -0.0107487 -0.00748469 -0.0355346 0.00746902 0.0 +257 2.55 3.55 123.75 0.00390058 0.039282 -0.00394485 -0.00836899 -0.0392871 0.00836606 0.0 +258 2.55 3.55 131.25 0.00302193 0.0417158 -0.00303302 -0.0116169 -0.0417316 0.0116365 0.0 +259 2.55 3.55 138.75 0.0132809 0.0429902 -0.0132594 -0.0177461 -0.0429583 0.0177101 0.0 +260 2.55 3.55 146.25 0.0286472 0.040296 -0.0286569 -0.0242602 -0.0403293 0.0242749 0.0 +261 2.55 3.55 153.75 0.0390318 0.0306394 -0.039064 -0.0280589 -0.0306446 0.028059 0.0 +262 2.55 3.55 161.25 0.0394296 0.0147367 -0.0394103 -0.0279664 -0.0146398 0.0279268 0.0 +263 2.55 3.55 168.75 0.0324474 -0.00226708 -0.0324635 -0.0253945 0.00220765 0.0254368 0.0 +264 2.55 3.55 176.25 0.025994 -0.013213 -0.0260157 -0.0230769 0.0131899 0.0230844 0.0 +265 2.55 3.65 3.75 -10.2735 4.76327 10.2735 20.7201 -4.76327 -20.7201 0.0 +266 2.55 3.65 11.25 -7.59679 3.74938 7.59679 12.2716 -3.74938 -12.2716 0.0 +267 2.55 3.65 18.75 -4.13373 2.33527 4.13373 4.48711 -2.33527 -4.48711 0.0 +268 2.55 3.65 26.25 -1.60809 1.11951 1.60809 1.05798 -1.11951 -1.05798 0.0 +269 2.55 3.65 33.75 -0.426582 0.367384 0.426586 0.237798 -0.367384 -0.237797 0.0 +270 2.55 3.65 41.25 -0.0923209 0.0481501 0.0923222 0.103116 -0.0481492 -0.103116 0.0 +271 2.55 3.65 48.75 -0.0403716 -0.019861 0.0403721 0.0289419 0.0198609 -0.0289447 0.0 +272 2.55 3.65 56.25 -0.0181588 -0.0104242 0.018157 -0.0111623 0.010423 0.0111643 0.0 +273 2.55 3.65 63.75 0.0026199 -0.0022943 -0.00261809 -0.0112332 0.00229608 0.011234 0.0 +274 2.55 3.65 71.25 0.00555137 -0.00054609 -0.00554585 -0.000901878 0.000542356 0.000901001 0.0 +275 2.55 3.65 78.75 -0.00349077 0.00348611 0.00348128 0.00388527 -0.0034823 -0.00388526 0.0 +276 2.55 3.65 86.25 -0.00986876 0.00759326 0.00986851 0.00334418 -0.00759374 -0.00334402 0.0 +277 2.55 3.65 93.75 -0.00861045 0.00735376 0.00861467 0.000656354 -0.00735444 -0.000656104 0.0 +278 2.55 3.65 101.25 -0.00414524 0.00377925 0.00414321 -0.00212584 -0.00377449 0.00212561 0.0 +279 2.55 3.65 108.75 -0.00169477 0.000439308 0.00169322 -0.00396038 -0.000442715 0.00396063 0.0 +280 2.55 3.65 116.25 -0.00201868 -0.000719026 0.00201981 -0.0047974 0.000729887 0.00479364 0.0 +281 2.55 3.65 123.75 -0.0022902 0.000305603 0.00229371 -0.00529632 -0.000307648 0.00529785 0.0 +282 2.55 3.65 131.25 6.5658e-05 0.00293592 -6.35245e-05 -0.00609152 -0.00294529 0.00609664 0.0 +283 2.55 3.65 138.75 0.00496513 0.00653024 -0.0049612 -0.00723673 -0.00653204 0.00723752 0.0 +284 2.55 3.65 146.25 0.0100844 0.0103162 -0.0100899 -0.0082568 -0.0103134 0.00825192 0.0 +285 2.55 3.65 153.75 0.013056 0.0135185 -0.0130568 -0.00863418 -0.0135186 0.00863497 0.0 +286 2.55 3.65 161.25 0.0130732 0.0156428 -0.013084 -0.00825131 -0.0156473 0.00825326 0.0 +287 2.55 3.65 168.75 0.0112797 0.0167179 -0.0112803 -0.00747124 -0.0167224 0.00747658 0.0 +288 2.55 3.65 176.25 0.0096521 0.0170897 -0.00964981 -0.00687278 -0.0170876 0.00686999 0.0 +289 2.65 2.65 3.75 -850.9 -766.532 850.9 24206.3 766.532 -24206.3 0.0 +290 2.65 2.65 11.25 -532.471 -481.095 532.471 5590.03 481.095 -5590.03 0.0 +291 2.65 2.65 18.75 -284.368 -250.886 284.368 1834.01 250.886 -1834.01 0.0 +292 2.65 2.65 26.25 -129.075 -106.598 129.075 555.283 106.598 -555.283 0.0 +293 2.65 2.65 33.75 -49.9399 -36.5293 49.9399 138.315 36.5293 -138.315 0.0 +294 2.65 2.65 41.25 -16.5129 -10.4032 16.5129 27.2019 10.4033 -27.2019 0.0 +295 2.65 2.65 48.75 -4.46528 -2.7076 4.46539 4.42411 2.70761 -4.42411 0.0 +296 2.65 2.65 56.25 -0.741021 -0.597377 0.741105 0.305553 0.597353 -0.305549 0.0 +297 2.65 2.65 63.75 0.104606 0.0237456 -0.104669 -0.572899 -0.0237444 0.572894 0.0 +298 2.65 2.65 71.25 0.139391 0.125946 -0.139515 -0.571709 -0.125927 0.571698 0.0 +299 2.65 2.65 78.75 0.104219 0.102894 -0.104113 -0.382665 -0.102882 0.382676 0.0 +300 2.65 2.65 86.25 0.157087 0.145852 -0.157232 -0.297431 -0.1459 0.297442 0.0 +301 2.65 2.65 93.75 0.240407 0.236266 -0.240541 -0.278188 -0.236265 0.27819 0.0 +302 2.65 2.65 101.25 0.275238 0.279291 -0.274988 -0.229799 -0.27936 0.229805 0.0 +303 2.65 2.65 108.75 0.227141 0.229356 -0.227284 -0.134968 -0.229285 0.134932 0.0 +304 2.65 2.65 116.25 0.115892 0.112442 -0.115868 -0.0291153 -0.112422 0.0291383 0.0 +305 2.65 2.65 123.75 -0.010285 -0.0162117 0.0103961 0.0530193 0.0161505 -0.0529991 0.0 +306 2.65 2.65 131.25 -0.1188 -0.124881 0.118875 0.104487 0.124916 -0.104492 0.0 +307 2.65 2.65 138.75 -0.223058 -0.229731 0.223369 0.145724 0.229737 -0.145685 0.0 +308 2.65 2.65 146.25 -0.368701 -0.376052 0.368859 0.205686 0.3761 -0.205685 0.0 +309 2.65 2.65 153.75 -0.587337 -0.594228 0.587423 0.299459 0.594372 -0.299509 0.0 +310 2.65 2.65 161.25 -0.859864 -0.865453 0.859988 0.416736 0.865344 -0.416708 0.0 +311 2.65 2.65 168.75 -1.11756 -1.12156 1.11739 0.526563 1.12147 -0.526502 0.0 +312 2.65 2.65 176.25 -1.2751 -1.27817 1.27506 0.593124 1.2781 -0.593061 0.0 +313 2.65 2.75 3.75 -835.182 -772.341 835.182 21905.9 772.341 -21905.9 0.0 +314 2.65 2.75 11.25 -513.694 -481.73 513.694 5723.06 481.73 -5723.06 0.0 +315 2.65 2.75 18.75 -261.725 -240.477 261.725 1876.13 240.477 -1876.13 0.0 +316 2.65 2.75 26.25 -110.82 -93.042 110.82 555.313 93.0419 -555.313 0.0 +317 2.65 2.75 33.75 -39.2645 -26.3478 39.2645 131.64 26.3478 -131.64 0.0 +318 2.65 2.75 41.25 -11.8937 -5.23302 11.8938 23.3148 5.233 -23.3148 0.0 +319 2.65 2.75 48.75 -3.05671 -0.993603 3.05657 3.14407 0.993621 -3.14406 0.0 +320 2.65 2.75 56.25 -0.550099 -0.358525 0.550227 0.163089 0.358498 -0.163112 0.0 +321 2.65 2.75 63.75 -0.0205929 -0.0842747 0.0205161 -0.407995 0.0842518 0.407956 0.0 +322 2.65 2.75 71.25 0.00336668 0.0345981 -0.00349936 -0.421497 -0.0346157 0.421506 0.0 +323 2.65 2.75 78.75 0.0253619 0.0593683 -0.0255874 -0.3063 -0.0593531 0.306294 0.0 +324 2.65 2.75 86.25 0.119248 0.114375 -0.119305 -0.255219 -0.114285 0.255229 0.0 +325 2.65 2.75 93.75 0.216069 0.202657 -0.216049 -0.241183 -0.202733 0.241187 0.0 +326 2.65 2.75 101.25 0.255314 0.253769 -0.255148 -0.201128 -0.253738 0.20113 0.0 +327 2.65 2.75 108.75 0.214511 0.222856 -0.214525 -0.121963 -0.222827 0.121965 0.0 +328 2.65 2.75 116.25 0.110921 0.123065 -0.110896 -0.0278056 -0.123096 0.027821 0.0 +329 2.65 2.75 123.75 -0.0119931 0.00216882 0.0119589 0.0508731 -0.00227192 -0.0508543 0.0 +330 2.65 2.75 131.25 -0.119575 -0.104676 0.119555 0.102045 0.10466 -0.10204 0.0 +331 2.65 2.75 138.75 -0.220603 -0.205567 0.220425 0.139953 0.205519 -0.139884 0.0 +332 2.65 2.75 146.25 -0.354901 -0.339963 0.354916 0.191191 0.340301 -0.191375 0.0 +333 2.65 2.75 153.75 -0.553233 -0.537535 0.553233 0.27207 0.537478 -0.272051 0.0 +334 2.65 2.75 161.25 -0.800056 -0.783314 0.80005 0.37528 0.783269 -0.375219 0.0 +335 2.65 2.75 168.75 -1.03362 -1.01636 1.03349 0.473222 1.01637 -0.473237 0.0 +336 2.65 2.75 176.25 -1.17633 -1.15917 1.17626 0.532997 1.15938 -0.533141 0.0 +337 2.65 2.85 3.75 -760.67 -716.576 760.67 16548.2 716.576 -16548.2 0.0 +338 2.65 2.85 11.25 -468.577 -458.252 468.577 5405.79 458.252 -5405.79 0.0 +339 2.65 2.85 18.75 -228.053 -226.497 228.053 1802.81 226.497 -1802.81 0.0 +340 2.65 2.85 26.25 -89.1662 -84.2911 89.1663 523.528 84.2911 -523.528 0.0 +341 2.65 2.85 33.75 -28.2756 -21.661 28.2757 117.98 21.661 -117.98 0.0 +342 2.65 2.85 41.25 -7.65848 -3.29349 7.65854 18.6016 3.29345 -18.6016 0.0 +343 2.65 2.85 48.75 -1.87861 -0.425521 1.87855 1.91342 0.425548 -1.91344 0.0 +344 2.65 2.85 56.25 -0.359414 -0.305329 0.359467 0.0202548 0.305288 -0.0202399 0.0 +345 2.65 2.85 63.75 -0.0454417 -0.184956 0.0452869 -0.276244 0.184875 0.276227 0.0 +346 2.65 2.85 71.25 -0.03328 -0.0799704 0.0333967 -0.292345 0.0799691 0.292342 0.0 +347 2.65 2.85 78.75 0.00639036 -0.0189859 -0.006449 -0.241547 0.0190153 0.241563 0.0 +348 2.65 2.85 86.25 0.102068 0.0661345 -0.102071 -0.222916 -0.0661619 0.222919 0.0 +349 2.65 2.85 93.75 0.188697 0.163968 -0.188721 -0.21219 -0.163988 0.212191 0.0 +350 2.65 2.85 101.25 0.22364 0.220472 -0.223377 -0.175014 -0.220473 0.175017 0.0 +351 2.65 2.85 108.75 0.190707 0.202776 -0.190758 -0.106231 -0.202789 0.106247 0.0 +352 2.65 2.85 116.25 0.101112 0.120884 -0.101059 -0.0239388 -0.120905 0.0239052 0.0 +353 2.65 2.85 123.75 -0.00702613 0.0160528 0.00714713 0.0453335 -0.0161052 -0.0453373 0.0 +354 2.65 2.85 131.25 -0.101648 -0.0781261 0.101387 0.088976 0.0781448 -0.0889832 0.0 +355 2.65 2.85 138.75 -0.188841 -0.166223 0.188892 0.119526 0.166146 -0.119525 0.0 +356 2.65 2.85 146.25 -0.306982 -0.284004 0.307036 0.162419 0.283915 -0.162404 0.0 +357 2.65 2.85 153.75 -0.48517 -0.45968 0.485006 0.233515 0.459501 -0.233437 0.0 +358 2.65 2.85 161.25 -0.709159 -0.680393 0.709041 0.326165 0.680286 -0.32613 0.0 +359 2.65 2.85 168.75 -0.921682 -0.890267 0.921631 0.414752 0.89028 -0.414752 0.0 +360 2.65 2.85 176.25 -1.05193 -1.01912 1.05183 0.468933 1.01918 -0.469002 0.0 +361 2.65 2.95 3.75 -652.979 -606.124 652.978 12075.3 606.124 -12075.3 0.0 +362 2.65 2.95 11.25 -403.824 -399.31 403.824 4765.3 399.31 -4765.3 0.0 +363 2.65 2.95 18.75 -187.153 -198.273 187.153 1631.6 198.273 -1631.6 0.0 +364 2.65 2.95 26.25 -66.1445 -73.0744 66.1444 465.712 73.0744 -465.712 0.0 +365 2.65 2.95 33.75 -17.7622 -18.4285 17.7623 99.7601 18.4285 -99.7601 0.0 +366 2.65 2.95 41.25 -3.98999 -2.7919 3.99011 13.9822 2.7919 -13.9822 0.0 +367 2.65 2.95 48.75 -0.962247 -0.422871 0.962286 1.0033 0.422848 -1.00329 0.0 +368 2.65 2.95 56.25 -0.219175 -0.313473 0.218952 -0.0875255 0.313511 0.0875306 0.0 +369 2.65 2.95 63.75 -0.044678 -0.231589 0.0446919 -0.204831 0.231605 0.204882 0.0 +370 2.65 2.95 71.25 -0.0396615 -0.157633 0.0394157 -0.207168 0.15761 0.207183 0.0 +371 2.65 2.95 78.75 0.000394622 -0.0817809 -0.000419789 -0.190543 0.0817504 0.19052 0.0 +372 2.65 2.95 86.25 0.0846769 0.0240518 -0.0846618 -0.190014 -0.0241096 0.19001 0.0 +373 2.65 2.95 93.75 0.158081 0.12764 -0.157821 -0.180645 -0.127555 0.18064 0.0 +374 2.65 2.95 101.25 0.189421 0.189324 -0.189292 -0.147352 -0.189274 0.147358 0.0 +375 2.65 2.95 108.75 0.164176 0.186927 -0.163977 -0.0895019 -0.186952 0.0894983 0.0 +376 2.65 2.95 116.25 0.0871432 0.125207 -0.0868669 -0.0199561 -0.125352 0.0199732 0.0 +377 2.65 2.95 123.75 -0.0085628 0.0365974 0.00860248 0.0390423 -0.0363033 -0.0391 0.0 +378 2.65 2.95 131.25 -0.0923265 -0.0482959 0.0922008 0.0760854 0.0485513 -0.0762079 0.0 +379 2.65 2.95 138.75 -0.169808 -0.131174 0.169899 0.102608 0.131327 -0.10265 0.0 +380 2.65 2.95 146.25 -0.277395 -0.242796 0.277398 0.141394 0.242783 -0.141344 0.0 +381 2.65 2.95 153.75 -0.440501 -0.407224 0.440757 0.205828 0.407133 -0.205796 0.0 +382 2.65 2.95 161.25 -0.645643 -0.610905 0.6459 0.288976 0.611281 -0.289147 0.0 +383 2.65 2.95 168.75 -0.840165 -0.802999 0.840107 0.367747 0.802858 -0.367578 0.0 +384 2.65 2.95 176.25 -0.958665 -0.920072 0.958486 0.415643 0.920088 -0.415608 0.0 +385 2.65 3.05 3.75 -535.332 -454.934 535.332 8760.56 454.934 -8760.56 0.0 +386 2.65 3.05 11.25 -331.494 -306.561 331.494 3960.52 306.561 -3960.52 0.0 +387 2.65 3.05 18.75 -145.715 -152.648 145.715 1393.82 152.648 -1393.82 0.0 +388 2.65 3.05 26.25 -45.1283 -55.696 45.1283 390.806 55.696 -390.806 0.0 +389 2.65 3.05 33.75 -9.03711 -13.9981 9.03714 79.4908 13.9982 -79.4908 0.0 +390 2.65 3.05 41.25 -1.22467 -2.35412 1.22472 9.98439 2.35415 -9.98442 0.0 +391 2.65 3.05 48.75 -0.350067 -0.498445 0.350201 0.482424 0.498397 -0.482377 0.0 +392 2.65 3.05 56.25 -0.145634 -0.296881 0.145625 -0.138328 0.296866 0.138253 0.0 +393 2.65 3.05 63.75 -0.0512301 -0.23938 0.0510461 -0.169789 0.239391 0.169777 0.0 +394 2.65 3.05 71.25 -0.0475131 -0.216688 0.0475797 -0.14914 0.21666 0.149179 0.0 +395 2.65 3.05 78.75 -0.0100019 -0.142708 0.0103876 -0.145447 0.142686 0.145453 0.0 +396 2.65 3.05 86.25 0.0629653 -0.0219697 -0.0630473 -0.155105 0.0219773 0.155114 0.0 +397 2.65 3.05 93.75 0.12664 0.0897788 -0.12658 -0.148638 -0.0897681 0.148648 0.0 +398 2.65 3.05 101.25 0.15677 0.161102 -0.15675 -0.121208 -0.161149 0.121229 0.0 +399 2.65 3.05 108.75 0.13765 0.175494 -0.137742 -0.0739815 -0.175467 0.0739654 0.0 +400 2.65 3.05 116.25 0.0719305 0.132074 -0.0719425 -0.0160117 -0.13204 0.0159808 0.0 +401 2.65 3.05 123.75 -0.0105205 0.0566312 0.0107171 0.0339816 -0.05635 -0.0341083 0.0 +402 2.65 3.05 131.25 -0.0825435 -0.0218324 0.0823353 0.0659987 0.0216974 -0.0659344 0.0 +403 2.65 3.05 138.75 -0.148847 -0.101917 0.149043 0.0897675 0.101945 -0.0897216 0.0 +404 2.65 3.05 146.25 -0.242919 -0.209388 0.242954 0.124121 0.209336 -0.12419 0.0 +405 2.65 3.05 153.75 -0.386426 -0.362461 0.386542 0.179324 0.362431 -0.179385 0.0 +406 2.65 3.05 161.25 -0.566176 -0.547526 0.566298 0.248855 0.547163 -0.248731 0.0 +407 2.65 3.05 168.75 -0.735042 -0.718844 0.735426 0.313712 0.718869 -0.313772 0.0 +408 2.65 3.05 176.25 -0.837976 -0.822371 0.837847 0.352792 0.822288 -0.352789 0.0 +409 2.65 3.15 3.75 -427.355 -285.2 427.355 6295.52 285.2 -6295.52 0.0 +410 2.65 3.15 11.25 -265.153 -194.02 265.153 3125.25 194.02 -3125.25 0.0 +411 2.65 3.15 18.75 -111.202 -95.1726 111.202 1125.35 95.1726 -1125.35 0.0 +412 2.65 3.15 26.25 -29.6517 -33.3268 29.6517 308.747 33.3268 -308.747 0.0 +413 2.65 3.15 33.75 -3.36664 -8.0325 3.36662 59.3209 8.03251 -59.3209 0.0 +414 2.65 3.15 41.25 0.370119 -1.56003 -0.370195 6.73765 1.55997 -6.73765 0.0 +415 2.65 3.15 48.75 -0.0293352 -0.505394 0.0293329 0.248728 0.505409 -0.248723 0.0 +416 2.65 3.15 56.25 -0.105843 -0.270835 0.105751 -0.145765 0.270743 0.145803 0.0 +417 2.65 3.15 63.75 -0.0513317 -0.246866 0.0514241 -0.147382 0.246878 0.147378 0.0 +418 2.65 3.15 71.25 -0.0501128 -0.275431 0.04993 -0.104001 0.275378 0.10398 0.0 +419 2.65 3.15 78.75 -0.0164568 -0.206434 0.0163659 -0.104649 0.206543 0.1047 0.0 +420 2.65 3.15 86.25 0.0461547 -0.0733023 -0.0462363 -0.11996 0.0733698 0.119964 0.0 +421 2.65 3.15 93.75 0.0990004 0.0476562 -0.0990613 -0.115936 -0.0477138 0.115929 0.0 +422 2.65 3.15 101.25 0.124404 0.129396 -0.124624 -0.0943304 -0.129428 0.0943415 0.0 +423 2.65 3.15 108.75 0.110989 0.159191 -0.110618 -0.0576564 -0.159015 0.0576196 0.0 +424 2.65 3.15 116.25 0.0587243 0.132639 -0.0587968 -0.0121644 -0.132721 0.0121638 0.0 +425 2.65 3.15 123.75 -0.00573936 0.071577 0.00545961 0.0272095 -0.0714379 -0.0272703 0.0 +426 2.65 3.15 131.25 -0.0595329 0.00372402 0.0596701 0.0523942 -0.00377444 -0.0523371 0.0 +427 2.65 3.15 138.75 -0.110101 -0.0680458 0.109914 0.0711533 0.0677435 -0.071079 0.0 +428 2.65 3.15 146.25 -0.183484 -0.162436 0.183193 0.097899 0.16187 -0.0976014 0.0 +429 2.65 3.15 153.75 -0.297201 -0.294331 0.297328 0.13994 0.294371 -0.13996 0.0 +430 2.65 3.15 161.25 -0.440022 -0.45053 0.440364 0.191997 0.45081 -0.192128 0.0 +431 2.65 3.15 168.75 -0.573979 -0.593135 0.574118 0.23999 0.593252 -0.240079 0.0 +432 2.65 3.15 176.25 -0.655332 -0.678506 0.655274 0.268714 0.678407 -0.2687 0.0 +433 2.65 3.25 3.75 -343.28 -124.107 343.28 4445.63 124.107 -4445.63 0.0 +434 2.65 3.25 11.25 -215.576 -82.5722 215.576 2350.25 82.5722 -2350.25 0.0 +435 2.65 3.25 18.75 -89.1611 -36.9434 89.1611 858.678 36.9434 -858.678 0.0 +436 2.65 3.25 26.25 -21.9322 -10.3742 21.9323 228.574 10.3742 -228.574 0.0 +437 2.65 3.25 33.75 -1.31403 -1.72106 1.31403 40.8621 1.72107 -40.8621 0.0 +438 2.65 3.25 41.25 0.795648 -0.575902 -0.795697 4.14894 0.57591 -4.14896 0.0 +439 2.65 3.25 48.75 0.0763357 -0.456169 -0.076398 0.148004 0.456256 -0.148065 0.0 +440 2.65 3.25 56.25 -0.063689 -0.249401 0.0637021 -0.13222 0.249531 0.132205 0.0 +441 2.65 3.25 63.75 -0.0358554 -0.249745 0.0359111 -0.121502 0.249724 0.121491 0.0 +442 2.65 3.25 71.25 -0.0428349 -0.311738 0.0428194 -0.0638131 0.311734 0.0637754 0.0 +443 2.65 3.25 78.75 -0.0147141 -0.250034 0.0144509 -0.0678206 0.250075 0.0677768 0.0 +444 2.65 3.25 86.25 0.0352991 -0.11503 -0.0353655 -0.0843742 0.115078 0.0843892 0.0 +445 2.65 3.25 93.75 0.0720144 0.00909964 -0.0719435 -0.0804605 -0.0090581 0.0804531 0.0 +446 2.65 3.25 101.25 0.0888655 0.0989902 -0.0887325 -0.0647524 -0.0990223 0.0647474 0.0 +447 2.65 3.25 108.75 0.0799171 0.143831 -0.0801351 -0.0405357 -0.143865 0.0405626 0.0 +448 2.65 3.25 116.25 0.0463151 0.13551 -0.0462271 -0.0103342 -0.135713 0.0104217 0.0 +449 2.65 3.25 123.75 0.00341445 0.0908375 -0.00340467 0.0161085 -0.0908948 -0.0161034 0.0 +450 2.65 3.25 131.25 -0.0328772 0.0354199 0.0327234 0.0332693 -0.0353895 -0.0333584 0.0 +451 2.65 3.25 138.75 -0.0675007 -0.0244596 0.0674606 0.0466046 0.0245277 -0.0466162 0.0 +452 2.65 3.25 146.25 -0.119973 -0.102745 0.119865 0.0658272 0.102678 -0.0658241 0.0 +453 2.65 3.25 153.75 -0.201674 -0.208813 0.202075 0.0954721 0.209073 -0.0955902 0.0 +454 2.65 3.25 161.25 -0.304347 -0.332116 0.304539 0.131641 0.332258 -0.131649 0.0 +455 2.65 3.25 168.75 -0.400265 -0.443353 0.400058 0.164689 0.443498 -0.164816 0.0 +456 2.65 3.25 176.25 -0.458148 -0.509414 0.458013 0.184384 0.509501 -0.184446 0.0 +457 2.65 3.35 3.75 -278.227 3.35188 278.227 2946.21 -3.35188 -2946.21 0.0 +458 2.65 3.35 11.25 -180.202 7.30679 180.202 1622.2 -7.30679 -1622.2 0.0 +459 2.65 3.35 18.75 -77.9402 10.1339 77.9402 594.724 -10.1339 -594.724 0.0 +460 2.65 3.35 26.25 -20.9467 8.02501 20.9466 151.361 -8.02502 -151.361 0.0 +461 2.65 3.35 33.75 -2.25835 3.3951 2.25826 24.3523 -3.39512 -24.3522 0.0 +462 2.65 3.35 41.25 0.363524 0.335418 -0.363448 2.07799 -0.335341 -2.07804 0.0 +463 2.65 3.35 48.75 0.0599237 -0.367988 -0.059957 0.0931953 0.367953 -0.0931855 0.0 +464 2.65 3.35 56.25 -0.0236982 -0.242143 0.0236458 -0.098598 0.242167 0.0985908 0.0 +465 2.65 3.35 63.75 -0.0239201 -0.250568 0.023879 -0.0793347 0.250659 0.0793004 0.0 +466 2.65 3.35 71.25 -0.0368509 -0.319915 0.0367806 -0.0239745 0.319926 0.0239988 0.0 +467 2.65 3.35 78.75 -0.0110244 -0.268487 0.0110139 -0.0344337 0.268438 0.0344165 0.0 +468 2.65 3.35 86.25 0.0245226 -0.144794 -0.024666 -0.0497857 0.144602 0.0497966 0.0 +469 2.65 3.35 93.75 0.0424081 -0.0251599 -0.0424651 -0.0453306 0.0251858 0.0453233 0.0 +470 2.65 3.35 101.25 0.04903 0.0707895 -0.0493151 -0.0359067 -0.0707318 0.0358776 0.0 +471 2.65 3.35 108.75 0.0471092 0.130164 -0.0471373 -0.0244748 -0.130189 0.0244837 0.0 +472 2.65 3.35 116.25 0.0314376 0.139837 -0.0314698 -0.00916072 -0.139805 0.00913728 0.0 +473 2.65 3.35 123.75 0.00660309 0.109671 -0.00661976 0.00590828 -0.109418 -0.00599612 0.0 +474 2.65 3.35 131.25 -0.0184331 0.0620534 0.0189306 0.0173272 -0.0619207 -0.0174002 0.0 +475 2.65 3.35 138.75 -0.0453275 0.00760214 0.0452428 0.0275525 -0.00734601 -0.027681 0.0 +476 2.65 3.35 146.25 -0.082266 -0.0599492 0.082171 0.0416578 0.0599927 -0.0416724 0.0 +477 2.65 3.35 153.75 -0.136274 -0.146184 0.136402 0.0620795 0.146055 -0.0619743 0.0 +478 2.65 3.35 161.25 -0.202661 -0.24297 0.20278 0.086379 0.243041 -0.0864087 0.0 +479 2.65 3.35 168.75 -0.264667 -0.328848 0.264622 0.108466 0.328816 -0.108439 0.0 +480 2.65 3.35 176.25 -0.302166 -0.379469 0.302333 0.121649 0.379451 -0.121585 0.0 +481 2.65 3.45 3.75 -181.094 56.5768 181.094 1415.07 -56.5768 -1415.07 0.0 +482 2.65 3.45 11.25 -122.646 43.7184 122.646 798.081 -43.7184 -798.081 0.0 +483 2.65 3.45 18.75 -57.6293 27.3547 57.6292 289.903 -27.3547 -289.903 0.0 +484 2.65 3.45 26.25 -18.2701 13.6208 18.2701 69.1213 -13.6207 -69.1213 0.0 +485 2.65 3.45 33.75 -3.43227 4.75555 3.43223 9.49818 -4.75554 -9.49816 0.0 +486 2.65 3.45 41.25 -0.262119 0.743592 0.262138 0.642703 -0.743569 -0.64265 0.0 +487 2.65 3.45 48.75 -0.0206249 -0.220801 0.0206949 0.0833427 0.220803 -0.0833703 0.0 +488 2.65 3.45 56.25 -0.0278092 -0.219147 0.0277268 -0.0418895 0.219207 0.0419362 0.0 +489 2.65 3.45 63.75 -0.0302865 -0.221675 0.0303371 -0.0292143 0.221725 0.0292088 0.0 +490 2.65 3.45 71.25 -0.0283973 -0.257992 0.0284536 0.00362643 0.257937 -0.00359012 0.0 +491 2.65 3.45 78.75 -0.00583895 -0.217814 0.00603552 -0.0105431 0.217741 0.0105389 0.0 +492 2.65 3.45 86.25 0.0119324 -0.129526 -0.0119649 -0.0224338 0.129557 0.0224452 0.0 +493 2.65 3.45 93.75 0.0144366 -0.0428903 -0.0145475 -0.0187179 0.0429014 0.0187299 0.0 +494 2.65 3.45 101.25 0.0149629 0.0297917 -0.015042 -0.0130715 -0.0298841 0.013074 0.0 +495 2.65 3.45 108.75 0.0176727 0.0802808 -0.0176481 -0.00859687 -0.0801128 0.00854075 0.0 +496 2.65 3.45 116.25 0.0142801 0.0968509 -0.0142142 -0.00275531 -0.0968446 0.00279613 0.0 +497 2.65 3.45 123.75 0.00274599 0.0822463 -0.00285046 0.00385754 -0.0822624 -0.00387098 0.0 +498 2.65 3.45 131.25 -0.0115459 0.0508246 0.0116421 0.00941126 -0.0506893 -0.00950556 0.0 +499 2.65 3.45 138.75 -0.0256544 0.0123774 0.0254092 0.0140698 -0.0124329 -0.0139752 0.0 +500 2.65 3.45 146.25 -0.0416502 -0.0338945 0.0416358 0.0199093 0.0339039 -0.0199382 0.0 +501 2.65 3.45 153.75 -0.06548 -0.0902951 0.0654101 0.02876 0.0902214 -0.0286754 0.0 +502 2.65 3.45 161.25 -0.0968618 -0.152516 0.096841 0.0402396 0.152761 -0.0403307 0.0 +503 2.65 3.45 168.75 -0.128132 -0.207768 0.128088 0.0514288 0.207796 -0.0514167 0.0 +504 2.65 3.45 176.25 -0.147889 -0.240577 0.147879 0.058392 0.24052 -0.0584226 0.0 +505 2.65 3.55 3.75 -77.1979 33.0526 77.1979 408.269 -33.0526 -408.269 0.0 +506 2.65 3.55 11.25 -54.4456 24.806 54.4456 233.071 -24.806 -233.071 0.0 +507 2.65 3.55 18.75 -27.4729 14.6982 27.4729 83.0823 -14.6982 -83.0823 0.0 +508 2.65 3.55 26.25 -9.74029 6.98034 9.74028 18.3878 -6.98034 -18.3878 0.0 +509 2.65 3.55 33.75 -2.26688 2.44976 2.26686 2.2212 -2.44975 -2.22122 0.0 +510 2.65 3.55 41.25 -0.338901 0.452784 0.338876 0.250018 -0.452783 -0.250042 0.0 +511 2.65 3.55 48.75 -0.085801 -0.0837087 0.0858276 0.0833161 0.0837009 -0.0833153 0.0 +512 2.65 3.55 56.25 -0.053787 -0.114074 0.0537453 -0.0208865 0.114083 0.0208809 0.0 +513 2.65 3.55 63.75 -0.0249841 -0.102636 0.0249818 -0.0169731 0.102618 0.0169814 0.0 +514 2.65 3.55 71.25 -0.00793484 -0.104993 0.0079199 0.00243536 0.104968 -0.00244121 0.0 +515 2.65 3.55 78.75 0.000477289 -0.083635 -0.000473373 -0.0028304 0.083634 0.00283354 0.0 +516 2.65 3.55 86.25 0.00225691 -0.0484377 -0.00227501 -0.00865479 0.0484012 0.00865592 0.0 +517 2.65 3.55 93.75 0.00072074 -0.0198074 -0.000659016 -0.00641186 0.0197662 0.00641637 0.0 +518 2.65 3.55 101.25 0.00112223 0.00094823 -0.0011259 -0.00217623 -0.000927796 0.00217226 0.0 +519 2.65 3.55 108.75 0.00303859 0.0169456 -0.0030474 0.000636489 -0.0170012 -0.000616911 0.0 +520 2.65 3.55 116.25 0.00293939 0.0254903 -0.00299498 0.00226534 -0.0254881 -0.00227427 0.0 +521 2.65 3.55 123.75 0.00105767 0.0250956 -0.00100249 0.00302411 -0.0251043 -0.00302286 0.0 +522 2.65 3.55 131.25 0.00089622 0.018822 -0.000861732 0.00254531 -0.0188028 -0.00256904 0.0 +523 2.65 3.55 138.75 0.00382565 0.0100627 -0.0038702 0.000936262 -0.0101195 -0.000921113 0.0 +524 2.65 3.55 146.25 0.00637878 -0.00112474 -0.0063611 -0.000499545 0.00116119 0.000462636 0.0 +525 2.65 3.55 153.75 0.00342379 -0.0163538 -0.00340327 -0.0001089 0.0163686 9.31942e-05 0.0 +526 2.65 3.55 161.25 -0.0063525 -0.0350349 0.00642576 0.00261085 0.0350954 -0.00266173 0.0 +527 2.65 3.55 168.75 -0.0193118 -0.0529521 0.01932 0.00641632 0.0530167 -0.00647477 0.0 +528 2.65 3.55 176.25 -0.0282729 -0.0640227 0.0283342 0.00913184 0.0640796 -0.00915341 0.0 +529 2.65 3.65 3.75 -9.07399 3.23181 9.07399 31.5979 -3.23181 -31.5979 0.0 +530 2.65 3.65 11.25 -6.54957 2.36668 6.54957 18.1922 -2.36668 -18.1922 0.0 +531 2.65 3.65 18.75 -3.41782 1.35636 3.41782 6.44075 -1.35636 -6.44075 0.0 +532 2.65 3.65 26.25 -1.25794 0.63761 1.25794 1.4388 -0.63761 -1.4388 0.0 +533 2.65 3.65 33.75 -0.314954 0.229217 0.314955 0.252105 -0.229219 -0.252103 0.0 +534 2.65 3.65 41.25 -0.0703285 0.0433984 0.0703295 0.0804037 -0.0433987 -0.080406 0.0 +535 2.65 3.65 48.75 -0.0346923 -0.00594178 0.0346905 0.0178914 0.00594136 -0.0178931 0.0 +536 2.65 3.65 56.25 -0.0178793 -0.00218658 0.0178826 -0.0109585 0.00218474 0.0109613 0.0 +537 2.65 3.65 63.75 -0.00296649 0.00371443 0.00296685 -0.0077863 -0.00371456 0.00778602 0.0 +538 2.65 3.65 71.25 0.00156936 0.00391538 -0.00157049 -0.000554586 -0.00391343 0.000556069 0.0 +539 2.65 3.65 78.75 4.72839e-05 0.00437901 -5.76159e-05 0.000766606 -0.00437852 -0.000767667 0.0 +540 2.65 3.65 86.25 -0.00150151 0.00465743 0.00150145 4.48359e-05 -0.00465746 -4.47759e-05 0.0 +541 2.65 3.65 93.75 -0.00154911 0.0023728 0.00155712 3.94444e-05 -0.00237267 -3.93568e-05 0.0 +542 2.65 3.65 101.25 -0.00102647 -0.00107232 0.0010322 0.000455843 0.00107411 -0.000456348 0.0 +543 2.65 3.65 108.75 -0.000931385 -0.00331098 0.000926423 0.000617065 0.00331642 -0.000619741 0.0 +544 2.65 3.65 116.25 -0.00125989 -0.00405896 0.00125662 0.000489735 0.00405917 -0.000489051 0.0 +545 2.65 3.65 123.75 -0.00119027 -0.00416793 0.00118127 0.00025776 0.00417216 -0.000258364 0.0 +546 2.65 3.65 131.25 2.02558e-06 -0.00385544 9.97877e-07 -5.65576e-05 0.00385538 5.6561e-05 0.0 +547 2.65 3.65 138.75 0.0019471 -0.0027434 -0.00193851 -0.000439961 0.00274576 0.000440451 0.0 +548 2.65 3.65 146.25 0.00340728 -0.000754999 -0.00340313 -0.000680537 0.000762165 0.000677165 0.0 +549 2.65 3.65 153.75 0.00324508 0.00162334 -0.00324525 -0.000497576 -0.00162245 0.000496814 0.0 +550 2.65 3.65 161.25 0.00132741 0.00369896 -0.00132849 0.000164919 -0.00371082 -0.000158918 0.0 +551 2.65 3.65 168.75 -0.00130947 0.00507786 0.00131187 0.00102227 -0.00507988 -0.00102051 0.0 +552 2.65 3.65 176.25 -0.00317672 0.00571563 0.00316942 0.00161776 -0.00571614 -0.00161842 0.0 +553 2.75 2.75 3.75 -953.112 -854.306 953.112 25981 854.306 -25981 0.0 +554 2.75 2.75 11.25 -539.051 -520.941 539.051 5855.95 520.941 -5855.95 0.0 +555 2.75 2.75 18.75 -242.983 -254.204 242.983 1824.66 254.204 -1824.66 0.0 +556 2.75 2.75 26.25 -83.2573 -94.4794 83.2573 502.272 94.4793 -502.272 0.0 +557 2.75 2.75 33.75 -20.5412 -24.7823 20.5412 104.828 24.7823 -104.828 0.0 +558 2.75 2.75 41.25 -3.9136 -4.29412 3.91362 14.9464 4.2941 -14.9465 0.0 +559 2.75 2.75 48.75 -1.12328 -0.873619 1.12322 1.93019 0.873624 -1.93018 0.0 +560 2.75 2.75 56.25 -0.514324 -0.496154 0.514312 0.391368 0.496221 -0.39134 0.0 +561 2.75 2.75 63.75 -0.164596 -0.213443 0.164691 -0.208447 0.213484 0.208481 0.0 +562 2.75 2.75 71.25 -0.041967 -0.0485499 0.0420123 -0.328452 0.0485135 0.328445 0.0 +563 2.75 2.75 78.75 0.00770861 0.0144404 -0.0076428 -0.256255 -0.0144125 0.25625 0.0 +564 2.75 2.75 86.25 0.090797 0.0907928 -0.090835 -0.225168 -0.0907865 0.225168 0.0 +565 2.75 2.75 93.75 0.181978 0.179759 -0.182045 -0.218388 -0.179673 0.218388 0.0 +566 2.75 2.75 101.25 0.225859 0.223811 -0.2259 -0.17996 -0.22375 0.17996 0.0 +567 2.75 2.75 108.75 0.197221 0.193022 -0.197213 -0.105534 -0.19316 0.105561 0.0 +568 2.75 2.75 116.25 0.109362 0.103419 -0.109316 -0.0211263 -0.10351 0.0211473 0.0 +569 2.75 2.75 123.75 0.00356169 -0.00337669 -0.00365545 0.0468134 0.00343037 -0.0468135 0.0 +570 2.75 2.75 131.25 -0.0899181 -0.097849 0.0896843 0.0904862 0.0978568 -0.090473 0.0 +571 2.75 2.75 138.75 -0.180752 -0.189165 0.180483 0.124806 0.189251 -0.124873 0.0 +572 2.75 2.75 146.25 -0.307245 -0.315227 0.307006 0.173842 0.315177 -0.173832 0.0 +573 2.75 2.75 153.75 -0.495888 -0.504071 0.495883 0.250885 0.504047 -0.250882 0.0 +574 2.75 2.75 161.25 -0.730452 -0.740638 0.730449 0.347741 0.740677 -0.347784 0.0 +575 2.75 2.75 168.75 -0.951281 -0.965256 0.9512 0.438629 0.965085 -0.438584 0.0 +576 2.75 2.75 176.25 -1.08583 -1.10279 1.08592 0.493743 1.10285 -0.493793 0.0 +577 2.75 2.85 3.75 -970.563 -775.744 970.563 23153.2 775.744 -23153.2 0.0 +578 2.75 2.85 11.25 -556.721 -474.097 556.721 5862.74 474.097 -5862.74 0.0 +579 2.75 2.85 18.75 -250.751 -224.584 250.751 1827.2 224.584 -1827.2 0.0 +580 2.75 2.85 26.25 -86.059 -77.5526 86.059 494.052 77.5526 -494.052 0.0 +581 2.75 2.85 33.75 -21.7848 -16.8577 21.7848 99.2767 16.8577 -99.2767 0.0 +582 2.75 2.85 41.25 -4.50961 -1.52272 4.5095 12.9376 1.52274 -12.9376 0.0 +583 2.75 2.85 48.75 -1.25065 -0.243785 1.25071 1.39261 0.243763 -1.39263 0.0 +584 2.75 2.85 56.25 -0.463066 -0.460087 0.463015 0.300113 0.460075 -0.300136 0.0 +585 2.75 2.85 63.75 -0.151187 -0.275288 0.151132 -0.144808 0.275348 0.144857 0.0 +586 2.75 2.85 71.25 -0.0749749 -0.110892 0.0749169 -0.249281 0.110829 0.249264 0.0 +587 2.75 2.85 78.75 -0.0201116 -0.0351113 0.0202283 -0.210984 0.0351362 0.210976 0.0 +588 2.75 2.85 86.25 0.0736389 0.0501401 -0.0736054 -0.194737 -0.0502144 0.194733 0.0 +589 2.75 2.85 93.75 0.160078 0.146192 -0.159898 -0.1879 -0.146241 0.187904 0.0 +590 2.75 2.85 101.25 0.200786 0.204303 -0.200728 -0.156391 -0.204259 0.156374 0.0 +591 2.75 2.85 108.75 0.17997 0.193028 -0.179585 -0.0955768 -0.192919 0.0955569 0.0 +592 2.75 2.85 116.25 0.103624 0.119278 -0.103941 -0.0221991 -0.119219 0.0221951 0.0 +593 2.75 2.85 123.75 0.00644177 0.0211333 -0.00659697 0.0394802 -0.0210367 -0.0394978 0.0 +594 2.75 2.85 131.25 -0.0803186 -0.0672129 0.080414 0.0781492 0.0671178 -0.0781413 0.0 +595 2.75 2.85 138.75 -0.161637 -0.148838 0.161505 0.105436 0.149111 -0.105534 0.0 +596 2.75 2.85 146.25 -0.270086 -0.257695 0.270083 0.14428 0.257823 -0.144344 0.0 +597 2.75 2.85 153.75 -0.43239 -0.421507 0.432363 0.208547 0.421587 -0.208591 0.0 +598 2.75 2.85 161.25 -0.634898 -0.628455 0.634872 0.291785 0.628448 -0.291789 0.0 +599 2.75 2.85 168.75 -0.826247 -0.825693 0.826352 0.370982 0.825733 -0.37098 0.0 +600 2.75 2.85 176.25 -0.943351 -0.946865 0.943117 0.419282 0.946914 -0.419356 0.0 +601 2.75 2.95 3.75 -897.538 -636.356 897.538 17274.5 636.356 -17274.5 0.0 +602 2.75 2.95 11.25 -527.594 -400.007 527.594 5426.93 400.007 -5426.93 0.0 +603 2.75 2.95 18.75 -234.856 -188.606 234.856 1719.6 188.606 -1719.6 0.0 +604 2.75 2.95 26.25 -78.0109 -63.1924 78.0109 457.632 63.1924 -457.632 0.0 +605 2.75 2.95 33.75 -18.5523 -12.6415 18.5523 88.2261 12.6415 -88.2261 0.0 +606 2.75 2.95 41.25 -3.43241 -0.788747 3.43237 10.3311 0.788758 -10.3311 0.0 +607 2.75 2.95 48.75 -0.834456 -0.199558 0.834517 0.799118 0.199613 -0.799125 0.0 +608 2.75 2.95 56.25 -0.273778 -0.463123 0.273749 0.148104 0.463143 -0.148167 0.0 +609 2.75 2.95 63.75 -0.103413 -0.318818 0.103504 -0.111608 0.31885 0.111645 0.0 +610 2.75 2.95 71.25 -0.0843263 -0.181793 0.0843793 -0.175312 0.181809 0.175287 0.0 +611 2.75 2.95 78.75 -0.0303993 -0.093494 0.0304044 -0.167209 0.0935528 0.167232 0.0 +612 2.75 2.95 86.25 0.0620423 0.00699782 -0.0622995 -0.169543 -0.00683051 0.169553 0.0 +613 2.75 2.95 93.75 0.136614 0.106217 -0.136678 -0.163514 -0.106191 0.163506 0.0 +614 2.75 2.95 101.25 0.17196 0.170249 -0.171903 -0.134812 -0.170364 0.13483 0.0 +615 2.75 2.95 108.75 0.15684 0.174342 -0.156924 -0.0828548 -0.174193 0.082802 0.0 +616 2.75 2.95 116.25 0.0926482 0.118695 -0.0927901 -0.0195911 -0.118646 0.0195826 0.0 +617 2.75 2.95 123.75 0.00849675 0.0355959 -0.00833828 0.0336514 -0.0356652 -0.0336479 0.0 +618 2.75 2.95 131.25 -0.0660839 -0.0418908 0.0662238 0.0659291 0.041797 -0.065883 0.0 +619 2.75 2.95 138.75 -0.134275 -0.114174 0.134106 0.0880437 0.114322 -0.0880806 0.0 +620 2.75 2.95 146.25 -0.227305 -0.21177 0.227027 0.121094 0.2116 -0.121002 0.0 +621 2.75 2.95 153.75 -0.368554 -0.358527 0.368374 0.177219 0.358663 -0.177335 0.0 +622 2.75 2.95 161.25 -0.546482 -0.542986 0.546711 0.250148 0.542877 -0.250051 0.0 +623 2.75 2.95 168.75 -0.715439 -0.717898 0.715379 0.319323 0.717937 -0.319304 0.0 +624 2.75 2.95 176.25 -0.817997 -0.824689 0.818295 0.361371 0.825027 -0.361574 0.0 +625 2.75 3.05 3.75 -770.161 -463.434 770.161 12393.7 463.434 -12393.7 0.0 +626 2.75 3.05 11.25 -462.237 -301.474 462.237 4693.99 301.474 -4693.99 0.0 +627 2.75 3.05 18.75 -201.495 -143.479 201.495 1525.17 143.479 -1525.17 0.0 +628 2.75 3.05 26.25 -62.9238 -47.8688 62.9238 399.794 47.8688 -399.794 0.0 +629 2.75 3.05 33.75 -12.9682 -9.61891 12.9682 73.8547 9.61892 -73.8547 0.0 +630 2.75 3.05 41.25 -1.7583 -0.85457 1.75829 7.81837 0.854518 -7.81834 0.0 +631 2.75 3.05 48.75 -0.381642 -0.346117 0.381587 0.40516 0.34605 -0.405176 0.0 +632 2.75 3.05 56.25 -0.163641 -0.440252 0.163583 0.0381865 0.440156 -0.0381959 0.0 +633 2.75 3.05 63.75 -0.103568 -0.332346 0.103485 -0.0833787 0.332372 0.0833554 0.0 +634 2.75 3.05 71.25 -0.101444 -0.24461 0.101602 -0.107568 0.244525 0.107546 0.0 +635 2.75 3.05 78.75 -0.038508 -0.1504 0.038783 -0.1224 0.150253 0.122395 0.0 +636 2.75 3.05 86.25 0.0496984 -0.0343332 -0.0494439 -0.140095 0.0345932 0.140101 0.0 +637 2.75 3.05 93.75 0.111297 0.06995 -0.111612 -0.135869 -0.0701637 0.135882 0.0 +638 2.75 3.05 101.25 0.140426 0.140943 -0.140275 -0.110396 -0.140778 0.110407 0.0 +639 2.75 3.05 108.75 0.12795 0.158778 -0.128322 -0.0664922 -0.158818 0.0664985 0.0 +640 2.75 3.05 116.25 0.0728381 0.119891 -0.0730793 -0.0130873 -0.11982 0.0129934 0.0 +641 2.75 3.05 123.75 0.000267345 0.0511317 -9.01598e-05 0.0314953 -0.0510922 -0.03149 0.0 +642 2.75 3.05 131.25 -0.063069 -0.0174406 0.0628665 0.0580034 0.0170276 -0.0579042 0.0 +643 2.75 3.05 138.75 -0.119018 -0.0842153 0.11903 0.0763319 0.0841315 -0.0762935 0.0 +644 2.75 3.05 146.25 -0.197865 -0.1752 0.197467 0.104414 0.175196 -0.104295 0.0 +645 2.75 3.05 153.75 -0.319615 -0.309756 0.319424 0.151665 0.309809 -0.15167 0.0 +646 2.75 3.05 161.25 -0.473103 -0.474577 0.47295 0.212121 0.474601 -0.212138 0.0 +647 2.75 3.05 168.75 -0.617392 -0.628077 0.617611 0.268756 0.627819 -0.268631 0.0 +648 2.75 3.05 176.25 -0.705354 -0.720636 0.705297 0.302934 0.720794 -0.303013 0.0 +649 2.75 3.15 3.75 -621.059 -283.307 621.059 8818.58 283.307 -8818.58 0.0 +650 2.75 3.15 11.25 -378.076 -190.869 378.076 3830.09 190.869 -3830.09 0.0 +651 2.75 3.15 18.75 -160.427 -92.3481 160.427 1277.7 92.3481 -1277.7 0.0 +652 2.75 3.15 26.25 -45.9966 -30.9532 45.9966 329.373 30.9532 -329.373 0.0 +653 2.75 3.15 33.75 -7.4094 -6.49374 7.40945 58.1344 6.49371 -58.1344 0.0 +654 2.75 3.15 41.25 -0.360268 -0.948504 0.360207 5.64912 0.948525 -5.64911 0.0 +655 2.75 3.15 48.75 -0.109681 -0.454359 0.109583 0.215632 0.454311 -0.215651 0.0 +656 2.75 3.15 56.25 -0.128581 -0.381055 0.12849 -0.024614 0.380998 0.0245607 0.0 +657 2.75 3.15 63.75 -0.107772 -0.325095 0.107852 -0.0656164 0.325178 0.0656213 0.0 +658 2.75 3.15 71.25 -0.10009 -0.293719 0.100061 -0.059479 0.293753 0.059475 0.0 +659 2.75 3.15 78.75 -0.036158 -0.200438 0.0358502 -0.0856231 0.200546 0.0856524 0.0 +660 2.75 3.15 86.25 0.0377439 -0.0742392 -0.037571 -0.109183 0.0742289 0.109172 0.0 +661 2.75 3.15 93.75 0.0838315 0.0343987 -0.0838656 -0.104987 -0.0344864 0.105012 0.0 +662 2.75 3.15 101.25 0.106057 0.110494 -0.106108 -0.0834801 -0.110598 0.0834927 0.0 +663 2.75 3.15 108.75 0.0968552 0.139813 -0.0967877 -0.0483794 -0.139765 0.0483448 0.0 +664 2.75 3.15 116.25 0.051391 0.115917 -0.0515763 -0.0060004 -0.116112 0.00610288 0.0 +665 2.75 3.15 123.75 -0.00713598 0.0613642 0.00718246 0.0286098 -0.0614779 -0.0285439 0.0 +666 2.75 3.15 131.25 -0.0559847 0.00396885 0.0560961 0.0483465 -0.00390007 -0.0484359 0.0 +667 2.75 3.15 138.75 -0.0990609 -0.0545791 0.0984659 0.061732 0.0548182 -0.0618343 0.0 +668 2.75 3.15 146.25 -0.159454 -0.134936 0.1595 0.0827794 0.135061 -0.08272 0.0 +669 2.75 3.15 153.75 -0.25524 -0.251075 0.255086 0.118141 0.251122 -0.118172 0.0 +670 2.75 3.15 161.25 -0.375288 -0.38964 0.375663 0.162894 0.389747 -0.16293 0.0 +671 2.75 3.15 168.75 -0.488486 -0.516392 0.488643 0.204424 0.516148 -0.204273 0.0 +672 2.75 3.15 176.25 -0.556839 -0.591689 0.556911 0.229329 0.591767 -0.229304 0.0 +673 2.75 3.25 3.75 -476.667 -121.19 476.667 6210.58 121.19 -6210.58 0.0 +674 2.75 3.25 11.25 -293.373 -85.8334 293.373 2968.1 85.8334 -2968.1 0.0 +675 2.75 3.25 18.75 -121.508 -42.7495 121.508 1012.27 42.7495 -1012.27 0.0 +676 2.75 3.25 26.25 -31.8786 -14.325 31.8786 255.334 14.325 -255.334 0.0 +677 2.75 3.25 33.75 -3.63288 -3.16546 3.63301 42.6516 3.16544 -42.6516 0.0 +678 2.75 3.25 41.25 0.315726 -0.793557 -0.315791 3.80727 0.79365 -3.8073 0.0 +679 2.75 3.25 48.75 -0.0242544 -0.460584 0.0242178 0.130581 0.460619 -0.130536 0.0 +680 2.75 3.25 56.25 -0.0991531 -0.30838 0.0992679 -0.0606306 0.308269 0.0605918 0.0 +681 2.75 3.25 63.75 -0.0775749 -0.303078 0.0775341 -0.058713 0.303134 0.0587059 0.0 +682 2.75 3.25 71.25 -0.0726081 -0.316404 0.0725509 -0.0320203 0.316355 0.0321083 0.0 +683 2.75 3.25 78.75 -0.0250871 -0.232854 0.0249036 -0.0576022 0.232759 0.0576201 0.0 +684 2.75 3.25 86.25 0.0262879 -0.108161 -0.0264355 -0.0771184 0.108011 0.0771155 0.0 +685 2.75 3.25 93.75 0.0560476 -0.000207024 -0.0559883 -0.0716051 0.000146475 0.0716155 0.0 +686 2.75 3.25 101.25 0.072468 0.0806321 -0.0723149 -0.0559611 -0.0805163 0.0559016 0.0 +687 2.75 3.25 108.75 0.0683282 0.121003 -0.068317 -0.0319853 -0.121 0.0319423 0.0 +688 2.75 3.25 116.25 0.0376756 0.112607 -0.037291 -0.00283035 -0.112703 0.00284452 0.0 +689 2.75 3.25 123.75 -0.00470402 0.0730337 0.00443815 0.0205484 -0.072994 -0.0206443 0.0 +690 2.75 3.25 131.25 -0.0393657 0.0275953 0.0393646 0.0333389 -0.02763 -0.0332308 0.0 +691 2.75 3.25 138.75 -0.0690594 -0.0208708 0.0692442 0.0419952 0.0207699 -0.0419967 0.0 +692 2.75 3.25 146.25 -0.111014 -0.0862657 0.110952 0.0560987 0.0863438 -0.0561322 0.0 +693 2.75 3.25 153.75 -0.176809 -0.178443 0.176496 0.0798216 0.178512 -0.0798746 0.0 +694 2.75 3.25 161.25 -0.258767 -0.286055 0.259122 0.109635 0.286421 -0.109773 0.0 +695 2.75 3.25 168.75 -0.336709 -0.383242 0.3365 0.137155 0.383371 -0.137249 0.0 +696 2.75 3.25 176.25 -0.383233 -0.440518 0.383304 0.153612 0.440294 -0.153402 0.0 +697 2.75 3.35 3.75 -341.385 1.74756 341.385 4134.74 -1.74757 -4134.74 0.0 +698 2.75 3.35 11.25 -213.168 -3.19693 213.168 2109.24 3.19691 -2109.24 0.0 +699 2.75 3.35 18.75 -87.8275 -2.99417 87.8276 729.622 2.99416 -729.622 0.0 +700 2.75 3.35 26.25 -22.0888 -0.704944 22.0887 178.369 0.70499 -178.369 0.0 +701 2.75 3.35 33.75 -2.07542 -0.0682655 2.0755 27.6089 0.0682662 -27.6089 0.0 +702 2.75 3.35 41.25 0.300247 -0.350456 -0.300305 2.18926 0.350473 -2.18927 0.0 +703 2.75 3.35 48.75 -0.0373785 -0.369541 0.0374118 0.0833796 0.36958 -0.083402 0.0 +704 2.75 3.35 56.25 -0.0518069 -0.259322 0.0517312 -0.0686295 0.259412 0.0687251 0.0 +705 2.75 3.35 63.75 -0.0322367 -0.285586 0.0323754 -0.0471277 0.285461 0.0471608 0.0 +706 2.75 3.35 71.25 -0.0437375 -0.317171 0.043788 -0.0133265 0.317084 0.0133532 0.0 +707 2.75 3.35 78.75 -0.0172441 -0.248737 0.0171536 -0.0330689 0.248747 0.0330618 0.0 +708 2.75 3.35 86.25 0.0144849 -0.135178 -0.014571 -0.0452186 0.135353 0.0452189 0.0 +709 2.75 3.35 93.75 0.030471 -0.0300865 -0.030347 -0.0398041 0.0300945 0.0397911 0.0 +710 2.75 3.35 101.25 0.0406014 0.0563913 -0.0407253 -0.0312837 -0.0564639 0.0312859 0.0 +711 2.75 3.35 108.75 0.0422766 0.108893 -0.0423538 -0.0189637 -0.109138 0.0190212 0.0 +712 2.75 3.35 116.25 0.0267588 0.115186 -0.0269597 -0.00297617 -0.11525 0.00295127 0.0 +713 2.75 3.35 123.75 0.000501099 0.0878862 -0.000774694 0.0104498 -0.0881349 -0.0102325 0.0 +714 2.75 3.35 131.25 -0.0236225 0.0489236 0.0238085 0.0185255 -0.0490552 -0.0184822 0.0 +715 2.75 3.35 138.75 -0.0444452 0.00629968 0.044223 0.0246731 -0.00652667 -0.0245664 0.0 +716 2.75 3.35 146.25 -0.0693381 -0.0474412 0.069485 0.0339103 0.0474594 -0.0339419 0.0 +717 2.75 3.35 153.75 -0.107186 -0.118947 0.107138 0.0484857 0.1189 -0.0484203 0.0 +718 2.75 3.35 161.25 -0.154793 -0.200912 0.154723 0.0665572 0.200588 -0.0663788 0.0 +719 2.75 3.35 168.75 -0.200583 -0.274251 0.200264 0.0833152 0.274149 -0.0833102 0.0 +720 2.75 3.35 176.25 -0.22795 -0.317539 0.228214 0.0934114 0.317615 -0.093522 0.0 +721 2.75 3.45 3.75 -181.602 50.4515 181.602 2007.55 -50.4515 -2007.55 0.0 +722 2.75 3.45 11.25 -116.135 31.353 116.135 1069.23 -31.3531 -1069.23 0.0 +723 2.75 3.45 18.75 -49.1544 14.1197 49.1544 371.433 -14.1197 -371.433 0.0 +724 2.75 3.45 26.25 -12.9027 5.27843 12.9027 86.871 -5.27842 -86.871 0.0 +725 2.75 3.45 33.75 -1.53044 1.58922 1.53042 12.1098 -1.58919 -12.1098 0.0 +726 2.75 3.45 41.25 0.0034182 0.175305 -0.00341175 0.852259 -0.175314 -0.852262 0.0 +727 2.75 3.45 48.75 -0.0627082 -0.187051 0.0626463 0.0745378 0.187162 -0.0745079 0.0 +728 2.75 3.45 56.25 -0.0269175 -0.208615 0.0269865 -0.0380544 0.208565 0.0380413 0.0 +729 2.75 3.45 63.75 -0.0156683 -0.232533 0.0156754 -0.0230666 0.232476 0.0230535 0.0 +730 2.75 3.45 71.25 -0.027083 -0.247837 0.027041 5.30776e-05 0.247723 -0.000124963 0.0 +731 2.75 3.45 78.75 -0.0110419 -0.199747 0.0110237 -0.01275 0.199733 0.0127249 0.0 +732 2.75 3.45 86.25 0.00600723 -0.118375 -0.00584057 -0.01943 0.118327 0.0194294 0.0 +733 2.75 3.45 93.75 0.00873478 -0.0394094 -0.00879205 -0.0152652 0.0394659 0.0152585 0.0 +734 2.75 3.45 101.25 0.00962037 0.0272073 -0.00960224 -0.0103152 -0.0271381 0.0103031 0.0 +735 2.75 3.45 108.75 0.0122306 0.0719369 -0.0122886 -0.00545491 -0.071926 0.00547195 0.0 +736 2.75 3.45 116.25 0.00974245 0.0846866 -0.00979763 -2.00295e-05 -0.084746 5.2625e-05 0.0 +737 2.75 3.45 123.75 0.000243929 0.070346 -0.000352399 0.00484904 -0.0702929 -0.00489636 0.0 +738 2.75 3.45 131.25 -0.010453 0.043801 0.0102586 0.00831848 -0.0439736 -0.00824598 0.0 +739 2.75 3.45 138.75 -0.0180464 0.0137037 0.0179837 0.0107806 -0.0137201 -0.0108167 0.0 +740 2.75 3.45 146.25 -0.025475 -0.0218772 0.0256088 0.0136926 0.0220646 -0.0138449 0.0 +741 2.75 3.45 153.75 -0.0382383 -0.0672046 0.0382092 0.0186021 0.0672579 -0.018626 0.0 +742 2.75 3.45 161.25 -0.0575259 -0.119353 0.0574959 0.0256839 0.119252 -0.0256513 0.0 +743 2.75 3.45 168.75 -0.0781428 -0.166869 0.078149 0.0330717 0.16689 -0.0331148 0.0 +744 2.75 3.45 176.25 -0.0916728 -0.195518 0.0917779 0.0378401 0.195665 -0.037981 0.0 +745 2.75 3.55 3.75 -60.5153 27.692 60.5153 588.046 -27.692 -588.046 0.0 +746 2.75 3.55 11.25 -39.8784 17.4201 39.8784 321.892 -17.4201 -321.892 0.0 +747 2.75 3.55 18.75 -17.6334 7.7718 17.6334 111.365 -7.7718 -111.365 0.0 +748 2.75 3.55 26.25 -4.94614 2.91047 4.94616 24.801 -2.91047 -24.801 0.0 +749 2.75 3.55 33.75 -0.717862 1.02613 0.717872 3.21211 -1.02616 -3.21209 0.0 +750 2.75 3.55 41.25 -0.0703286 0.253386 0.0703577 0.326292 -0.253389 -0.326305 0.0 +751 2.75 3.55 48.75 -0.0696314 -0.0360868 0.0696098 0.0745468 0.0361057 -0.0745544 0.0 +752 2.75 3.55 56.25 -0.0386849 -0.0894109 0.0386635 -0.0191097 0.0894516 0.0190794 0.0 +753 2.75 3.55 63.75 -0.0158765 -0.0925221 0.0158458 -0.0145167 0.09256 0.0145237 0.0 +754 2.75 3.55 71.25 -0.00997075 -0.0929607 0.00998059 0.000467248 0.0929809 -0.000443377 0.0 +755 2.75 3.55 78.75 -0.00149974 -0.0734939 0.00146198 -0.00355586 0.0735358 0.00355353 0.0 +756 2.75 3.55 86.25 0.0028805 -0.042718 -0.00289025 -0.00634796 0.0427423 0.00634686 0.0 +757 2.75 3.55 93.75 -0.000895397 -0.0173398 0.000915914 -0.00268197 0.0173692 0.00268557 0.0 +758 2.75 3.55 101.25 -0.00461455 0.00200332 0.00464936 0.00177679 -0.00195006 -0.0017874 0.0 +759 2.75 3.55 108.75 -0.00367123 0.0176377 0.00372332 0.00363241 -0.0176972 -0.00361264 0.0 +760 2.75 3.55 116.25 -0.00131124 0.0260317 0.00133193 0.00346321 -0.0260021 -0.00346733 0.0 +761 2.75 3.55 123.75 -0.000257145 0.0251737 0.000204938 0.00292588 -0.0251838 -0.00291469 0.0 +762 2.75 3.55 131.25 0.000973531 0.0188626 -0.000971992 0.00228745 -0.0188196 -0.00232812 0.0 +763 2.75 3.55 138.75 0.00409367 0.011615 -0.00404917 0.000911448 -0.011591 -0.000925473 0.0 +764 2.75 3.55 146.25 0.00744491 0.00348645 -0.0075166 -0.000905243 -0.00344952 0.000869305 0.0 +765 2.75 3.55 153.75 0.00762023 -0.00783196 -0.00763712 -0.00180907 0.00784858 0.00180265 0.0 +766 2.75 3.55 161.25 0.00271034 -0.0229315 -0.00264761 -0.000890015 0.0229401 0.000888095 0.0 +767 2.75 3.55 168.75 -0.0051415 -0.0382675 0.00514139 0.00125874 0.0383533 -0.00131918 0.0 +768 2.75 3.55 176.25 -0.0109249 -0.0480268 0.0109626 0.00300256 0.0480665 -0.00301775 0.0 +769 2.75 3.65 3.75 -5.4585 2.19054 5.4585 46.1523 -2.19054 -46.1523 0.0 +770 2.75 3.65 11.25 -3.66097 1.22096 3.66097 25.7483 -1.22096 -25.7483 0.0 +771 2.75 3.65 18.75 -1.63156 0.409151 1.63156 8.91799 -0.409152 -8.91799 0.0 +772 2.75 3.65 26.25 -0.435259 0.123143 0.435261 1.99397 -0.123144 -1.99397 0.0 +773 2.75 3.65 33.75 -0.0493642 0.0652704 0.0493648 0.328683 -0.0652688 -0.328684 0.0 +774 2.75 3.65 41.25 -0.0146925 0.0282769 0.0146967 0.0813637 -0.0282736 -0.0813666 0.0 +775 2.75 3.65 48.75 -0.0246544 0.00490522 0.0246565 0.0166878 -0.00490432 -0.0166888 0.0 +776 2.75 3.65 56.25 -0.0139125 0.00395284 0.0139089 -0.00867723 -0.00395188 0.00867599 0.0 +777 2.75 3.65 63.75 -0.00270241 0.00619066 0.00270068 -0.00571762 -0.00619525 0.00571944 0.0 +778 2.75 3.65 71.25 0.000519918 0.00471435 -0.000521654 -8.15984e-06 -0.00471422 7.2579e-06 0.0 +779 2.75 3.65 78.75 0.000501459 0.00398609 -0.00050026 0.000797399 -0.00398918 -0.000797502 0.0 +780 2.75 3.65 86.25 -4.4671e-05 0.00352149 4.27284e-05 0.000514162 -0.00352011 -0.000514185 0.0 +781 2.75 3.65 93.75 -0.000889969 0.00110883 0.000890202 0.00115235 -0.00110879 -0.00115223 0.0 +782 2.75 3.65 101.25 -0.00151239 -0.00165277 0.00151236 0.00181475 0.00164834 -0.00181365 0.0 +783 2.75 3.65 108.75 -0.00161992 -0.00273717 0.00161755 0.00169929 0.00273792 -0.00169984 0.0 +784 2.75 3.65 116.25 -0.00158692 -0.00271981 0.00158207 0.00119301 0.00272293 -0.00119423 0.0 +785 2.75 3.65 123.75 -0.00161004 -0.0028994 0.00160522 0.000901196 0.00289974 -0.000900406 0.0 +786 2.75 3.65 131.25 -0.00135618 -0.00318701 0.00134929 0.000817217 0.00318514 -0.000815958 0.0 +787 2.75 3.65 138.75 -0.000562397 -0.00258908 0.000562926 0.000632375 0.00259618 -0.000635132 0.0 +788 2.75 3.65 146.25 0.000398525 -0.000673377 -0.000405592 0.000326015 0.000673344 -0.000326095 0.0 +789 2.75 3.65 153.75 0.000850024 0.00202598 -0.000855047 0.000185369 -0.00202081 -0.000188642 0.0 +790 2.75 3.65 161.25 0.000434663 0.00458686 -0.000435573 0.000417059 -0.00458533 -0.000417937 0.0 +791 2.75 3.65 168.75 -0.000552814 0.00638533 0.000542524 0.000898487 -0.00637922 -0.0009015 0.0 +792 2.75 3.65 176.25 -0.00133582 0.00725755 0.00133015 0.00128127 -0.0072543 -0.00128197 0.0 +793 2.85 2.85 3.75 -1116.76 -835.91 1116.76 26640.2 835.91 -26640.2 0.0 +794 2.85 2.85 11.25 -610.386 -506.696 610.386 5875.84 506.696 -5875.84 0.0 +795 2.85 2.85 18.75 -255.208 -239.613 255.208 1744.42 239.613 -1744.42 0.0 +796 2.85 2.85 26.25 -73.7604 -82.5484 73.7603 437.327 82.5484 -437.327 0.0 +797 2.85 2.85 33.75 -11.1104 -18.0796 11.1103 74.9581 18.0796 -74.9581 0.0 +798 2.85 2.85 41.25 0.228715 -1.87052 -0.228784 6.31518 1.87054 -6.31516 0.0 +799 2.85 2.85 48.75 -0.186912 -0.383005 0.186932 0.552533 0.382981 -0.552553 0.0 +800 2.85 2.85 56.25 -0.516548 -0.486964 0.51651 0.427331 0.486994 -0.427316 0.0 +801 2.85 2.85 63.75 -0.277336 -0.279457 0.277442 -0.0294235 0.279516 0.0294254 0.0 +802 2.85 2.85 71.25 -0.12864 -0.127184 0.128869 -0.180718 0.127225 0.180733 0.0 +803 2.85 2.85 78.75 -0.0484987 -0.0475193 0.0484573 -0.172173 0.0474804 0.172167 0.0 +804 2.85 2.85 86.25 0.047169 0.0422314 -0.0471278 -0.173173 -0.0422364 0.173175 0.0 +805 2.85 2.85 93.75 0.132895 0.126705 -0.132882 -0.167927 -0.126598 0.167928 0.0 +806 2.85 2.85 101.25 0.176042 0.170333 -0.17625 -0.134397 -0.170485 0.134408 0.0 +807 2.85 2.85 108.75 0.163576 0.157905 -0.16355 -0.0779511 -0.157842 0.0779731 0.0 +808 2.85 2.85 116.25 0.101997 0.0960507 -0.102078 -0.014347 -0.0959807 0.0143824 0.0 +809 2.85 2.85 123.75 0.0206725 0.0134256 -0.0205836 0.0381676 -0.0135693 -0.0381435 0.0 +810 2.85 2.85 131.25 -0.0539648 -0.0618543 0.0539695 0.071669 0.061813 -0.0716401 0.0 +811 2.85 2.85 138.75 -0.126558 -0.13291 0.126595 0.096029 0.132846 -0.0960093 0.0 +812 2.85 2.85 146.25 -0.226905 -0.229729 0.2268 0.129945 0.229804 -0.130004 0.0 +813 2.85 2.85 153.75 -0.375777 -0.37653 0.375708 0.184542 0.376441 -0.184502 0.0 +814 2.85 2.85 161.25 -0.55951 -0.56228 0.559638 0.254398 0.562318 -0.254441 0.0 +815 2.85 2.85 168.75 -0.731663 -0.739479 0.731781 0.320527 0.739524 -0.32053 0.0 +816 2.85 2.85 176.25 -0.836402 -0.848187 0.836322 0.360778 0.848245 -0.36086 0.0 +817 2.85 2.95 3.75 -1111.67 -671.504 1111.67 23382.6 671.504 -23382.6 0.0 +818 2.85 2.95 11.25 -624.121 -411.338 624.121 5761.08 411.338 -5761.08 0.0 +819 2.85 2.95 18.75 -267.855 -190.585 267.855 1715.29 190.585 -1715.29 0.0 +820 2.85 2.95 26.25 -82.9178 -61.5016 82.9177 426.265 61.5016 -426.265 0.0 +821 2.85 2.95 33.75 -16.5392 -10.9568 16.5393 72.4347 10.9568 -72.4348 0.0 +822 2.85 2.95 41.25 -2.05368 -0.128524 2.05363 6.25085 0.128465 -6.25081 0.0 +823 2.85 2.95 48.75 -0.636623 -0.11763 0.63655 0.514257 0.117589 -0.514248 0.0 +824 2.85 2.95 56.25 -0.408465 -0.491652 0.408393 0.327192 0.491696 -0.327194 0.0 +825 2.85 2.95 63.75 -0.201297 -0.331339 0.201309 -0.0209138 0.331453 0.0209243 0.0 +826 2.85 2.95 71.25 -0.130914 -0.18282 0.130989 -0.130552 0.182746 0.130536 0.0 +827 2.85 2.95 78.75 -0.0608924 -0.0898709 0.0607915 -0.139463 0.0899889 0.139453 0.0 +828 2.85 2.95 86.25 0.0345738 0.00746434 -0.0344701 -0.148244 -0.00754141 0.148234 0.0 +829 2.85 2.95 93.75 0.111119 0.0976325 -0.1113 -0.142909 -0.0978809 0.142911 0.0 +830 2.85 2.95 101.25 0.151941 0.155503 -0.151976 -0.117111 -0.15543 0.11711 0.0 +831 2.85 2.95 108.75 0.145751 0.160353 -0.145553 -0.0726376 -0.160204 0.0725882 0.0 +832 2.85 2.95 116.25 0.0915158 0.110131 -0.0916919 -0.0182529 -0.110235 0.0182768 0.0 +833 2.85 2.95 123.75 0.0152377 0.0331448 -0.0151991 0.0284008 -0.0330236 -0.0284138 0.0 +834 2.85 2.95 131.25 -0.0546463 -0.0389944 0.0545777 0.0573967 0.038874 -0.0573186 0.0 +835 2.85 2.95 138.75 -0.1187 -0.104823 0.118718 0.0772008 0.104764 -0.077174 0.0 +836 2.85 2.95 146.25 -0.204059 -0.191464 0.203984 0.105389 0.191495 -0.105464 0.0 +837 2.85 2.95 153.75 -0.330797 -0.320794 0.330923 0.152322 0.320747 -0.152296 0.0 +838 2.85 2.95 161.25 -0.488129 -0.483077 0.488236 0.213067 0.483198 -0.213056 0.0 +839 2.85 2.95 168.75 -0.635592 -0.636761 0.635765 0.270692 0.636908 -0.270728 0.0 +840 2.85 2.95 176.25 -0.725217 -0.730636 0.725177 0.305753 0.730739 -0.305825 0.0 +841 2.85 3.05 3.75 -991.274 -468.465 991.274 17235.6 468.465 -17235.6 0.0 +842 2.85 3.05 11.25 -573.802 -298.761 573.802 5231.29 298.761 -5231.29 0.0 +843 2.85 3.05 18.75 -246.923 -139.586 246.923 1584.79 139.586 -1584.79 0.0 +844 2.85 3.05 26.25 -76.3431 -44.1795 76.3432 390.143 44.1795 -390.143 0.0 +845 2.85 3.05 33.75 -15.4296 -7.24375 15.4295 64.979 7.24375 -64.979 0.0 +846 2.85 3.05 41.25 -1.99485 0.0867799 1.99484 5.41934 -0.0867462 -5.41932 0.0 +847 2.85 3.05 48.75 -0.466876 -0.194309 0.466823 0.319783 0.194325 -0.319796 0.0 +848 2.85 3.05 56.25 -0.247864 -0.498556 0.247809 0.194278 0.49852 -0.194293 0.0 +849 2.85 3.05 63.75 -0.160838 -0.374237 0.160788 -0.00452736 0.374195 0.00453271 0.0 +850 2.85 3.05 71.25 -0.138726 -0.24602 0.138704 -0.0733155 0.246086 0.0732922 0.0 +851 2.85 3.05 78.75 -0.0645345 -0.137898 0.0646711 -0.10598 0.137892 0.105997 0.0 +852 2.85 3.05 86.25 0.0266641 -0.0289336 -0.0265391 -0.125218 0.0289426 0.125216 0.0 +853 2.85 3.05 93.75 0.0897391 0.0651921 -0.0895906 -0.118986 -0.0650775 0.118989 0.0 +854 2.85 3.05 101.25 0.124171 0.131613 -0.123901 -0.0965881 -0.131532 0.0965755 0.0 +855 2.85 3.05 108.75 0.12195 0.150621 -0.122014 -0.0600585 -0.150659 0.0600667 0.0 +856 2.85 3.05 116.25 0.0781014 0.115484 -0.0778585 -0.0147582 -0.115247 0.0147179 0.0 +857 2.85 3.05 123.75 0.0150628 0.0506384 -0.0150425 0.0236392 -0.0506457 -0.023627 0.0 +858 2.85 3.05 131.25 -0.0400525 -0.0131487 0.0399632 0.0466779 0.0130289 -0.0466525 0.0 +859 2.85 3.05 138.75 -0.0895184 -0.0739947 0.0894657 0.0627374 0.0740386 -0.0627861 0.0 +860 2.85 3.05 146.25 -0.15904 -0.155412 0.159469 0.0871229 0.155461 -0.0870861 0.0 +861 2.85 3.05 153.75 -0.267082 -0.274606 0.267172 0.127796 0.274496 -0.127765 0.0 +862 2.85 3.05 161.25 -0.401901 -0.419629 0.401826 0.179668 0.41968 -0.179776 0.0 +863 2.85 3.05 168.75 -0.527756 -0.553697 0.527878 0.228247 0.553582 -0.228199 0.0 +864 2.85 3.05 176.25 -0.604226 -0.634443 0.604143 0.25757 0.634535 -0.257606 0.0 +865 2.85 3.15 3.75 -806.102 -265.526 806.102 12165.1 265.526 -12165.1 0.0 +866 2.85 3.15 11.25 -477.611 -181.207 477.611 4442.53 181.207 -4442.53 0.0 +867 2.85 3.15 18.75 -202.862 -88.6434 202.862 1380.02 88.6434 -1380.02 0.0 +868 2.85 3.15 26.25 -60.0987 -29.0515 60.0987 336.188 29.0515 -336.188 0.0 +869 2.85 3.15 33.75 -10.968 -5.19052 10.9681 54.504 5.19046 -54.5041 0.0 +870 2.85 3.15 41.25 -1.05094 -0.312006 1.05086 4.33851 0.311981 -4.33846 0.0 +871 2.85 3.15 48.75 -0.213743 -0.352928 0.213728 0.164252 0.352886 -0.164263 0.0 +872 2.85 3.15 56.25 -0.154279 -0.471869 0.154225 0.093218 0.47198 -0.0932153 0.0 +873 2.85 3.15 63.75 -0.141604 -0.388768 0.141653 0.0126807 0.388761 -0.0126585 0.0 +874 2.85 3.15 71.25 -0.130127 -0.294635 0.130139 -0.0263984 0.294556 0.0263117 0.0 +875 2.85 3.15 78.75 -0.0550277 -0.180465 0.0550203 -0.073421 0.180561 0.0734297 0.0 +876 2.85 3.15 86.25 0.0209399 -0.0643701 -0.0207919 -0.0962653 0.0644703 0.0962704 0.0 +877 2.85 3.15 93.75 0.0659847 0.032253 -0.0661012 -0.0898107 -0.0322317 0.0898055 0.0 +878 2.85 3.15 101.25 0.0929454 0.104785 -0.092671 -0.0721152 -0.104858 0.0721226 0.0 +879 2.85 3.15 108.75 0.0923534 0.135562 -0.0925163 -0.0438144 -0.135405 0.0437756 0.0 +880 2.85 3.15 116.25 0.0576885 0.115491 -0.0573926 -0.00846383 -0.115386 0.00845008 0.0 +881 2.85 3.15 123.75 0.00835101 0.0659492 -0.00830537 0.0204391 -0.0659776 -0.020473 0.0 +882 2.85 3.15 131.25 -0.0330033 0.0137364 0.0330472 0.0368218 -0.0138501 -0.0368043 0.0 +883 2.85 3.15 138.75 -0.0696344 -0.0403338 0.0693805 0.0485567 0.0403552 -0.0486203 0.0 +884 2.85 3.15 146.25 -0.123646 -0.114761 0.123498 0.0676978 0.114704 -0.0677341 0.0 +885 2.85 3.15 153.75 -0.209228 -0.220305 0.209164 0.0995682 0.220152 -0.0994412 0.0 +886 2.85 3.15 161.25 -0.316292 -0.3444 0.316446 0.139549 0.344477 -0.139654 0.0 +887 2.85 3.15 168.75 -0.416182 -0.455814 0.416144 0.176494 0.455746 -0.176411 0.0 +888 2.85 3.15 176.25 -0.476042 -0.521785 0.476 0.198621 0.521756 -0.198557 0.0 +889 2.85 3.25 3.75 -599.006 -91.2154 599.006 8491.46 91.2155 -8491.46 0.0 +890 2.85 3.25 11.25 -359.488 -74.6727 359.488 3559.49 74.6727 -3559.49 0.0 +891 2.85 3.25 18.75 -148.661 -42.6777 148.661 1135.12 42.6777 -1135.12 0.0 +892 2.85 3.25 26.25 -40.7166 -16.0322 40.7166 272.812 16.0322 -272.812 0.0 +893 2.85 3.25 33.75 -5.97051 -3.67296 5.97039 42.68 3.67297 -42.68 0.0 +894 2.85 3.25 41.25 -0.182688 -0.670468 0.182753 3.20438 0.670474 -3.20441 0.0 +895 2.85 3.25 48.75 -0.0747798 -0.425329 0.0748223 0.0657742 0.425365 -0.0658515 0.0 +896 2.85 3.25 56.25 -0.0982934 -0.398958 0.0982134 0.0220039 0.399004 -0.0220176 0.0 +897 2.85 3.25 63.75 -0.100813 -0.360976 0.100898 0.0133885 0.360825 -0.0133447 0.0 +898 2.85 3.25 71.25 -0.0945309 -0.307881 0.0945963 -0.00420512 0.307879 0.00421061 0.0 +899 2.85 3.25 78.75 -0.0366795 -0.207353 0.0366632 -0.0482296 0.20741 0.0482248 0.0 +900 2.85 3.25 86.25 0.0149887 -0.0970942 -0.0150626 -0.0654125 0.0972336 0.0654212 0.0 +901 2.85 3.25 93.75 0.0443972 -0.00226785 -0.0443982 -0.0599009 0.00218497 0.0598939 0.0 +902 2.85 3.25 101.25 0.0653842 0.0743707 -0.0655475 -0.0488889 -0.074459 0.048906 0.0 +903 2.85 3.25 108.75 0.0673028 0.115282 -0.0672563 -0.0293956 -0.115121 0.0293551 0.0 +904 2.85 3.25 116.25 0.041101 0.109791 -0.041206 -0.00426137 -0.110092 0.0043584 0.0 +905 2.85 3.25 123.75 0.0030353 0.0756594 -0.00306469 0.0153374 -0.0756692 -0.0152926 0.0 +906 2.85 3.25 131.25 -0.02782 0.0350328 0.0279329 0.0256415 -0.0350474 -0.0256136 0.0 +907 2.85 3.25 138.75 -0.0538742 -0.00966993 0.0537414 0.0330967 0.00970634 -0.033162 0.0 +908 2.85 3.25 146.25 -0.0905357 -0.070843 0.0905608 0.0460454 0.0707919 -0.045972 0.0 +909 2.85 3.25 153.75 -0.14887 -0.15562 0.148901 0.0676893 0.155618 -0.067644 0.0 +910 2.85 3.25 161.25 -0.22216 -0.252709 0.22219 0.0946651 0.252847 -0.0946834 0.0 +911 2.85 3.25 168.75 -0.290593 -0.338691 0.290381 0.119487 0.33884 -0.119576 0.0 +912 2.85 3.25 176.25 -0.3308 -0.388801 0.331427 0.13433 0.388853 -0.134296 0.0 +913 2.85 3.35 3.75 -386.528 33.5021 386.528 5634.36 -33.5021 -5634.36 0.0 +914 2.85 3.35 11.25 -232.313 5.67109 232.313 2604.32 -5.67109 -2604.32 0.0 +915 2.85 3.35 18.75 -91.9697 -7.27714 91.9697 849.253 7.27716 -849.253 0.0 +916 2.85 3.35 26.25 -22.1609 -5.78613 22.161 200.148 5.78612 -200.148 0.0 +917 2.85 3.35 33.75 -1.98022 -2.12648 1.98024 29.7672 2.12648 -29.7672 0.0 +918 2.85 3.35 41.25 0.243179 -0.637377 -0.243178 2.04091 0.637344 -2.04094 0.0 +919 2.85 3.35 48.75 -0.0543799 -0.361761 0.0543227 0.0128587 0.36182 -0.0128186 0.0 +920 2.85 3.35 56.25 -0.053243 -0.315179 0.0533037 -0.0175621 0.315135 0.0175499 0.0 +921 2.85 3.35 63.75 -0.0463022 -0.314223 0.0463235 0.00311652 0.314212 -0.00320789 0.0 +922 2.85 3.35 71.25 -0.0532898 -0.296211 0.0534137 -0.000155585 0.29602 0.000135295 0.0 +923 2.85 3.35 78.75 -0.0212587 -0.22246 0.0212696 -0.0288431 0.222559 0.0288631 0.0 +924 2.85 3.35 86.25 0.00889954 -0.125343 -0.00894718 -0.0369629 0.125394 0.0369644 0.0 +925 2.85 3.35 93.75 0.0262325 -0.0313862 -0.0263584 -0.0340369 0.0311982 0.0340506 0.0 +926 2.85 3.35 101.25 0.0415953 0.0498466 -0.0414478 -0.0293926 -0.0498895 0.0293844 0.0 +927 2.85 3.35 108.75 0.0450451 0.0995096 -0.0449831 -0.0178232 -0.0997351 0.0178778 0.0 +928 2.85 3.35 116.25 0.028077 0.105738 -0.0281433 -0.00230595 -0.105795 0.00235292 0.0 +929 2.85 3.35 123.75 0.00116088 0.0815732 -0.000852722 0.00942911 -0.0816637 -0.00933158 0.0 +930 2.85 3.35 131.25 -0.0216069 0.0479562 0.0217652 0.0156247 -0.0476846 -0.0157325 0.0 +931 2.85 3.35 138.75 -0.0380909 0.0111308 0.0380157 0.0201099 -0.0113054 -0.0200733 0.0 +932 2.85 3.35 146.25 -0.0570642 -0.0359703 0.0570676 0.0273788 0.0359094 -0.0273053 0.0 +933 2.85 3.35 153.75 -0.0874487 -0.0993169 0.0874531 0.0394423 0.0994037 -0.0393806 0.0 +934 2.85 3.35 161.25 -0.127843 -0.172492 0.127557 0.054893 0.172359 -0.0549082 0.0 +935 2.85 3.35 168.75 -0.166559 -0.237682 0.166614 0.0695468 0.237554 -0.0695277 0.0 +936 2.85 3.35 176.25 -0.191 -0.276276 0.19078 0.0784958 0.276377 -0.0785403 0.0 +937 2.85 3.45 3.75 -161.588 70.6187 161.588 2741.33 -70.6187 -2741.33 0.0 +938 2.85 3.45 11.25 -95.5114 34.9158 95.5114 1355.81 -34.9158 -1355.81 0.0 +939 2.85 3.45 18.75 -34.6683 8.27267 34.6684 448.865 -8.27268 -448.865 0.0 +940 2.85 3.45 26.25 -6.16493 -0.139582 6.16494 102.857 0.139618 -102.857 0.0 +941 2.85 3.45 33.75 0.422229 -0.589501 -0.422207 14.2949 0.589425 -14.2948 0.0 +942 2.85 3.45 41.25 0.271293 -0.179716 -0.271334 0.90093 0.179724 -0.900935 0.0 +943 2.85 3.45 48.75 -0.0728654 -0.170806 0.0729137 0.0252674 0.1707 -0.025252 0.0 +944 2.85 3.45 56.25 -0.0333377 -0.213039 0.0332742 -0.0156257 0.212999 0.0155434 0.0 +945 2.85 3.45 63.75 -0.0152903 -0.227014 0.0151849 -0.00379666 0.227029 0.00381385 0.0 +946 2.85 3.45 71.25 -0.0235692 -0.224061 0.0235144 -0.000903934 0.22407 0.000862594 0.0 +947 2.85 3.45 78.75 -0.00941949 -0.180683 0.00940751 -0.0122182 0.180688 0.0122354 0.0 +948 2.85 3.45 86.25 0.00386563 -0.108855 -0.00384482 -0.0147672 0.108894 0.0147696 0.0 +949 2.85 3.45 93.75 0.00738598 -0.0352297 -0.00746621 -0.0134146 0.0352537 0.0134097 0.0 +950 2.85 3.45 101.25 0.0113163 0.0272447 -0.0112177 -0.0108832 -0.027162 0.0109037 0.0 +951 2.85 3.45 108.75 0.0143535 0.0674421 -0.0144727 -0.00585159 -0.0674317 0.00583747 0.0 +952 2.85 3.45 116.25 0.0102386 0.0775271 -0.0102071 -0.000339014 -0.0776401 0.000348303 0.0 +953 2.85 3.45 123.75 2.58732e-05 0.0640245 -4.10589e-05 0.00384167 -0.0641439 -0.00376402 0.0 +954 2.85 3.45 131.25 -0.00902431 0.0415235 0.00900971 0.00644527 -0.0416055 -0.00641701 0.0 +955 2.85 3.45 138.75 -0.0130822 0.0181696 0.0131824 0.00773263 -0.0182103 -0.00771311 0.0 +956 2.85 3.45 146.25 -0.0161839 -0.00998922 0.016076 0.00888536 0.00978667 -0.00879601 0.0 +957 2.85 3.45 153.75 -0.0242202 -0.0483692 0.0241807 0.011811 0.0483358 -0.0118472 0.0 +958 2.85 3.45 161.25 -0.0396328 -0.0952296 0.0395522 0.0172745 0.0951821 -0.0172176 0.0 +959 2.85 3.45 168.75 -0.0578248 -0.139644 0.0577311 0.0236934 0.13953 -0.0236387 0.0 +960 2.85 3.45 176.25 -0.0700834 -0.166806 0.0701114 0.0280544 0.166621 -0.0279388 0.0 +961 2.85 3.55 3.75 -31.029 33.8429 31.029 807.354 -33.8429 -807.354 0.0 +962 2.85 3.55 11.25 -16.6941 17.1581 16.6942 418.065 -17.1581 -418.065 0.0 +963 2.85 3.55 18.75 -3.99472 4.08748 3.9947 139.471 -4.08747 -139.471 0.0 +964 2.85 3.55 26.25 0.82754 0.00960473 -0.827538 30.9637 -0.00959943 -30.9637 0.0 +965 2.85 3.55 33.75 0.904557 -0.081934 -0.904543 4.11608 0.0819614 -4.11609 0.0 +966 2.85 3.55 41.25 0.170681 0.0848305 -0.170682 0.346509 -0.0848039 -0.34653 0.0 +967 2.85 3.55 48.75 -0.0666717 -0.0106917 0.0666836 0.0541797 0.0106909 -0.0541811 0.0 +968 2.85 3.55 56.25 -0.0367163 -0.0711844 0.0367427 -0.00758183 0.0712025 0.00758489 0.0 +969 2.85 3.55 63.75 -0.00980718 -0.0797592 0.00983424 -0.00697712 0.0797424 0.00697812 0.0 +970 2.85 3.55 71.25 -0.00586824 -0.0828521 0.00590764 -3.50261e-07 0.0828154 -9.47724e-06 0.0 +971 2.85 3.55 78.75 -0.000602709 -0.0682983 0.000612821 -0.00212227 0.0683145 0.00213184 0.0 +972 2.85 3.55 86.25 0.000973121 -0.0398569 -0.000961009 -0.00335451 0.0398316 0.00334909 0.0 +973 2.85 3.55 93.75 -0.00358082 -0.0150889 0.00357048 -0.00152868 0.0150508 0.00152981 0.0 +974 2.85 3.55 101.25 -0.00603736 0.00394172 0.00605293 0.000730934 -0.00393071 -0.000744155 0.0 +975 2.85 3.55 108.75 -0.00335262 0.0195109 0.00322804 0.00102238 -0.0194668 -0.00104163 0.0 +976 2.85 3.55 116.25 0.000444349 0.027755 -0.000387332 8.69624e-05 -0.0277462 -9.75392e-05 0.0 +977 2.85 3.55 123.75 0.0014088 0.0269113 -0.00138674 -7.73086e-05 -0.0268849 6.29337e-05 0.0 +978 2.85 3.55 131.25 0.00165964 0.0217477 -0.00165364 0.000223061 -0.0218041 -0.000187964 0.0 +979 2.85 3.55 138.75 0.00401875 0.0169663 -0.00395318 -0.000703326 -0.016976 0.000717988 0.0 +980 2.85 3.55 146.25 0.00768509 0.0118145 -0.00765824 -0.00287592 -0.0118411 0.00289573 0.0 +981 2.85 3.55 153.75 0.00912573 0.00261415 -0.00905729 -0.00443259 -0.00257542 0.00443667 0.0 +982 2.85 3.55 161.25 0.0057808 -0.0119115 -0.00584887 -0.00390544 0.0118818 0.00391874 0.0 +983 2.85 3.55 168.75 -0.000422092 -0.0276521 0.000431626 -0.00177835 0.0276894 0.00174946 0.0 +984 2.85 3.55 176.25 -0.00538109 -0.0379719 0.00540295 7.43942e-05 0.0379802 -5.26705e-05 0.0 +985 2.85 3.65 3.75 0.117993 2.41395 -0.117994 63.6242 -2.41395 -63.6242 0.0 +986 2.85 3.65 11.25 0.547196 0.863222 -0.547196 34.0061 -0.86322 -34.0061 0.0 +987 2.85 3.65 18.75 0.745937 -0.193692 -0.745936 11.4296 0.193693 -11.4296 0.0 +988 2.85 3.65 26.25 0.543519 -0.28335 -0.54352 2.53726 0.28335 -2.53726 0.0 +989 2.85 3.65 33.75 0.224853 -0.0795795 -0.224852 0.395802 0.0795803 -0.395805 0.0 +990 2.85 3.65 41.25 0.0308566 0.0096513 -0.030854 0.0760108 -0.00965396 -0.0760089 0.0 +991 2.85 3.65 48.75 -0.0200071 0.0114374 0.0200007 0.0152694 -0.0114346 -0.0152666 0.0 +992 2.85 3.65 56.25 -0.0121781 0.00806958 0.0121778 -0.00463886 -0.00806824 0.00463935 0.0 +993 2.85 3.65 63.75 -0.00240079 0.00691829 0.00239728 -0.00287853 -0.00691891 0.00287832 0.0 +994 2.85 3.65 71.25 -0.000113974 0.00344927 0.000114402 0.000925612 -0.00345159 -0.000924517 0.0 +995 2.85 3.65 78.75 -0.000150972 0.00204618 0.000149514 0.00127176 -0.00204528 -0.00127259 0.0 +996 2.85 3.65 86.25 -0.00063721 0.00167632 0.000641885 0.000872705 -0.00167479 -0.000872293 0.0 +997 2.85 3.65 93.75 -0.00144962 -0.000316034 0.00144811 0.00113858 0.000313733 -0.00113842 0.0 +998 2.85 3.65 101.25 -0.00167523 -0.00216785 0.00167369 0.00123363 0.00216868 -0.00123425 0.0 +999 2.85 3.65 108.75 -0.00110878 -0.00207464 0.00110977 0.00064396 0.00207751 -0.000643732 0.0 +1000 2.85 3.65 116.25 -0.000764004 -0.00128655 0.000766131 0.000103318 0.00128453 -0.000103182 0.0 +1001 2.85 3.65 123.75 -0.00123412 -0.00134957 0.00123183 0.000216939 0.00135724 -0.000220275 0.0 +1002 2.85 3.65 131.25 -0.00184917 -0.00183778 0.00184664 0.000577507 0.00184059 -0.000579396 0.0 +1003 2.85 3.65 138.75 -0.00163391 -0.00138008 0.00162307 0.000515544 0.00137553 -0.000512344 0.0 +1004 2.85 3.65 146.25 -0.000376327 0.000499681 0.00037387 -6.6379e-06 -0.000506003 1.01884e-05 0.0 +1005 2.85 3.65 153.75 0.00121458 0.00310539 -0.00122162 -0.000485719 -0.00311088 0.000488173 0.0 +1006 2.85 3.65 161.25 0.00238865 0.00543453 -0.0023833 -0.00051915 -0.00542809 0.000516147 0.0 +1007 2.85 3.65 168.75 0.00285962 0.00692717 -0.00285792 -0.000171476 -0.00692344 0.000168255 0.0 +1008 2.85 3.65 176.25 0.00292307 0.00758779 -0.00292581 0.00016883 -0.00759567 -0.000164093 0.0 +1009 2.95 2.95 3.75 -1235.79 -703.549 1235.79 26126.6 703.549 -26126.6 0.0 +1010 2.95 2.95 11.25 -677.675 -435.614 677.675 5671.31 435.614 -5671.31 0.0 +1011 2.95 2.95 18.75 -281.882 -206.464 281.882 1620.38 206.464 -1620.38 0.0 +1012 2.95 2.95 26.25 -80.142 -69.4145 80.142 377.367 69.4145 -377.367 0.0 +1013 2.95 2.95 33.75 -11.535 -14.0454 11.535 55.1741 14.0454 -55.1741 0.0 +1014 2.95 2.95 41.25 0.444691 -1.06867 -0.444678 2.44606 1.06872 -2.44609 0.0 +1015 2.95 2.95 48.75 -0.095339 -0.280002 0.095379 0.150135 0.280037 -0.150155 0.0 +1016 2.95 2.95 56.25 -0.487332 -0.457247 0.487298 0.373103 0.457341 -0.373058 0.0 +1017 2.95 2.95 63.75 -0.309733 -0.308057 0.309669 0.0352679 0.308082 -0.0352801 0.0 +1018 2.95 2.95 71.25 -0.189494 -0.187337 0.189429 -0.0767338 0.187338 0.0767722 0.0 +1019 2.95 2.95 78.75 -0.100558 -0.0943326 0.100538 -0.103742 0.0942838 0.103711 0.0 +1020 2.95 2.95 86.25 -0.00127159 0.00259697 0.00111691 -0.124177 -0.0027075 0.124174 0.0 +1021 2.95 2.95 93.75 0.0781938 0.0795056 -0.0783669 -0.119644 -0.0795165 0.119632 0.0 +1022 2.95 2.95 101.25 0.125437 0.125749 -0.125346 -0.0954926 -0.125695 0.0954816 0.0 +1023 2.95 2.95 108.75 0.131842 0.132451 -0.1318 -0.0582993 -0.132316 0.0582686 0.0 +1024 2.95 2.95 116.25 0.094036 0.0945768 -0.0939986 -0.013007 -0.0944018 0.0129685 0.0 +1025 2.95 2.95 123.75 0.031853 0.0309302 -0.0318676 0.0276584 -0.0309157 -0.0276663 0.0 +1026 2.95 2.95 131.25 -0.0289236 -0.0307662 0.0290267 0.0542911 0.0309129 -0.0543246 0.0 +1027 2.95 2.95 138.75 -0.0860191 -0.0873603 0.0858184 0.0715543 0.0871918 -0.0715138 0.0 +1028 2.95 2.95 146.25 -0.159015 -0.159395 0.158823 0.092785 0.159333 -0.0927604 0.0 +1029 2.95 2.95 153.75 -0.264066 -0.265928 0.264092 0.127317 0.266003 -0.127385 0.0 +1030 2.95 2.95 161.25 -0.392832 -0.399313 0.392736 0.172881 0.399453 -0.172904 0.0 +1031 2.95 2.95 168.75 -0.51305 -0.525949 0.512818 0.216982 0.526087 -0.217102 0.0 +1032 2.95 2.95 176.25 -0.585362 -0.603164 0.585535 0.244165 0.603114 -0.244128 0.0 +1033 2.95 3.05 3.75 -1152 -470.691 1152 22546.9 470.691 -22546.9 0.0 +1034 2.95 3.05 11.25 -646.366 -302.989 646.366 5436.44 302.989 -5436.44 0.0 +1035 2.95 3.05 18.75 -274.735 -144.566 274.735 1560.79 144.566 -1560.79 0.0 +1036 2.95 3.05 26.25 -82.9595 -46.7837 82.9596 363.128 46.7837 -363.128 0.0 +1037 2.95 3.05 33.75 -15.5348 -7.90904 15.5348 54.2888 7.90907 -54.2887 0.0 +1038 2.95 3.05 41.25 -1.52533 0.0877815 1.52529 3.23039 -0.0877658 -3.23043 0.0 +1039 2.95 3.05 48.75 -0.429791 -0.130249 0.429777 0.249314 0.130206 -0.249273 0.0 +1040 2.95 3.05 56.25 -0.354386 -0.465805 0.3544 0.285906 0.465883 -0.285905 0.0 +1041 2.95 3.05 63.75 -0.230807 -0.353693 0.230714 0.0451008 0.353768 -0.0451234 0.0 +1042 2.95 3.05 71.25 -0.171943 -0.228248 0.172051 -0.0442061 0.228171 0.0442394 0.0 +1043 2.95 3.05 78.75 -0.0886759 -0.125763 0.0886157 -0.0870429 0.125748 0.0870611 0.0 +1044 2.95 3.05 86.25 0.00406016 -0.0290639 -0.00400943 -0.106637 0.0291333 0.106635 0.0 +1045 2.95 3.05 93.75 0.0709324 0.0512843 -0.0709031 -0.0997352 -0.0513256 0.0997471 0.0 +1046 2.95 3.05 101.25 0.112173 0.109307 -0.112111 -0.081026 -0.10938 0.0810188 0.0 +1047 2.95 3.05 108.75 0.118241 0.127448 -0.118156 -0.0508854 -0.127498 0.0509172 0.0 +1048 2.95 3.05 116.25 0.082375 0.0967194 -0.0826216 -0.0115758 -0.096743 0.0116038 0.0 +1049 2.95 3.05 123.75 0.0249719 0.0392243 -0.0250633 0.0233571 -0.0393156 -0.0232965 0.0 +1050 2.95 3.05 131.25 -0.0283614 -0.0168684 0.0282743 0.0451621 0.0168661 -0.045173 0.0 +1051 2.95 3.05 138.75 -0.0768736 -0.0688048 0.077069 0.0594051 0.068716 -0.0593073 0.0 +1052 2.95 3.05 146.25 -0.141563 -0.136731 0.141568 0.0784955 0.136426 -0.0784076 0.0 +1053 2.95 3.05 153.75 -0.236122 -0.235072 0.236058 0.109983 0.235346 -0.110141 0.0 +1054 2.95 3.05 161.25 -0.351579 -0.354851 0.351474 0.150951 0.354689 -0.150832 0.0 +1055 2.95 3.05 168.75 -0.458428 -0.465918 0.458345 0.190063 0.465592 -0.18999 0.0 +1056 2.95 3.05 176.25 -0.522577 -0.532559 0.52258 0.213967 0.532625 -0.214084 0.0 +1057 2.95 3.15 3.75 -947.105 -234.064 947.105 16388.2 234.064 -16388.2 0.0 +1058 2.95 3.15 11.25 -544.957 -169.572 544.957 4831.85 169.572 -4831.85 0.0 +1059 2.95 3.15 18.75 -231.218 -87.4264 231.218 1411.96 87.4264 -1411.96 0.0 +1060 2.95 3.15 26.25 -69.489 -29.5946 69.489 327.211 29.5945 -327.211 0.0 +1061 2.95 3.15 33.75 -13.2484 -5.06717 13.2484 48.9414 5.06717 -48.9414 0.0 +1062 2.95 3.15 41.25 -1.4679 0.0238403 1.46795 3.15011 -0.0239097 -3.15014 0.0 +1063 2.95 3.15 48.75 -0.31652 -0.227201 0.316586 0.172569 0.227204 -0.17262 0.0 +1064 2.95 3.15 56.25 -0.21369 -0.480095 0.213689 0.184024 0.480141 -0.184087 0.0 +1065 2.95 3.15 63.75 -0.176969 -0.390853 0.176921 0.0560194 0.390826 -0.0559763 0.0 +1066 2.95 3.15 71.25 -0.150417 -0.269717 0.150456 -0.0151382 0.269771 0.0150882 0.0 +1067 2.95 3.15 78.75 -0.0732588 -0.158111 0.073298 -0.0675252 0.157991 0.0675219 0.0 +1068 2.95 3.15 86.25 0.0011828 -0.0578942 -0.0013546 -0.0836453 0.0579193 0.083656 0.0 +1069 2.95 3.15 93.75 0.0495663 0.0262723 -0.0495336 -0.0758505 -0.0265178 0.0758585 0.0 +1070 2.95 3.15 101.25 0.0825033 0.0923783 -0.0825646 -0.0624571 -0.0924447 0.0624949 0.0 +1071 2.95 3.15 108.75 0.0903024 0.12085 -0.0901393 -0.0395117 -0.120852 0.0395202 0.0 +1072 2.95 3.15 116.25 0.0638444 0.102339 -0.0638579 -0.00894728 -0.102235 0.00890468 0.0 +1073 2.95 3.15 123.75 0.0220461 0.0572511 -0.0219022 0.0169359 -0.0570113 -0.0169543 0.0 +1074 2.95 3.15 131.25 -0.015441 0.00943891 0.0156538 0.0325133 -0.00947592 -0.0324612 0.0 +1075 2.95 3.15 138.75 -0.0518112 -0.0403117 0.0516345 0.043965 0.0403656 -0.0440096 0.0 +1076 2.95 3.15 146.25 -0.104883 -0.106935 0.104923 0.0610883 0.106832 -0.0610049 0.0 +1077 2.95 3.15 153.75 -0.185793 -0.19961 0.185681 0.0885896 0.199403 -0.0885392 0.0 +1078 2.95 3.15 161.25 -0.283884 -0.306665 0.283899 0.123061 0.306488 -0.122974 0.0 +1079 2.95 3.15 168.75 -0.3736 -0.401945 0.373662 0.155182 0.401946 -0.155094 0.0 +1080 2.95 3.15 176.25 -0.427053 -0.458118 0.427085 0.174567 0.458223 -0.174634 0.0 +1081 2.95 3.25 3.75 -684.962 -33.597 684.962 11353.2 33.597 -11353.2 0.0 +1082 2.95 3.25 11.25 -400.069 -51.4433 400.069 4016.56 51.4433 -4016.56 0.0 +1083 2.95 3.25 18.75 -165.833 -38.5931 165.833 1203.1 38.5931 -1203.1 0.0 +1084 2.95 3.25 26.25 -47.263 -16.6148 47.263 276.987 16.6148 -276.987 0.0 +1085 2.95 3.25 33.75 -8.14408 -3.80756 8.14405 40.878 3.80754 -40.8779 0.0 +1086 2.95 3.25 41.25 -0.735673 -0.396549 0.73574 2.63773 0.396509 -2.63772 0.0 +1087 2.95 3.25 48.75 -0.150431 -0.333017 0.150544 0.0672603 0.332896 -0.0672187 0.0 +1088 2.95 3.25 56.25 -0.10876 -0.446971 0.10866 0.0972865 0.44696 -0.0973988 0.0 +1089 2.95 3.25 63.75 -0.118865 -0.37823 0.118992 0.0520019 0.378268 -0.052 0.0 +1090 2.95 3.25 71.25 -0.109895 -0.280626 0.109945 -0.000890606 0.280499 0.000905523 0.0 +1091 2.95 3.25 78.75 -0.0507365 -0.181073 0.0507334 -0.0461242 0.18097 0.0461348 0.0 +1092 2.95 3.25 86.25 -0.000734511 -0.0871476 0.00060714 -0.0555662 0.0872154 0.0555746 0.0 +1093 2.95 3.25 93.75 0.0311957 -0.00236195 -0.0311942 -0.0515041 0.00259597 0.0514843 0.0 +1094 2.95 3.25 101.25 0.0572093 0.0688848 -0.0571052 -0.0452318 -0.0687382 0.0452149 0.0 +1095 2.95 3.25 108.75 0.064287 0.106942 -0.0642778 -0.029198 -0.106939 0.0292002 0.0 +1096 2.95 3.25 116.25 0.0445212 0.10208 -0.0444717 -0.00721917 -0.102122 0.00721939 0.0 +1097 2.95 3.25 123.75 0.0135976 0.0703346 -0.0132914 0.0101515 -0.070214 -0.0102111 0.0 +1098 2.95 3.25 131.25 -0.0135575 0.0313234 0.0136726 0.0203596 -0.0316066 -0.0203055 0.0 +1099 2.95 3.25 138.75 -0.0393187 -0.0123616 0.0392606 0.0289017 0.0125322 -0.0289811 0.0 +1100 2.95 3.25 146.25 -0.0783219 -0.0713966 0.0781054 0.0422706 0.0716338 -0.0424701 0.0 +1101 2.95 3.25 153.75 -0.137718 -0.149787 0.137636 0.0630045 0.149918 -0.0630855 0.0 +1102 2.95 3.25 161.25 -0.209697 -0.23746 0.209832 0.0883427 0.237538 -0.0884379 0.0 +1103 2.95 3.25 168.75 -0.275371 -0.313873 0.275402 0.111664 0.314062 -0.111753 0.0 +1104 2.95 3.25 176.25 -0.314348 -0.358242 0.314391 0.125665 0.357993 -0.125515 0.0 +1105 2.95 3.35 3.75 -399.508 103.619 399.508 7451.41 -103.619 -7451.41 0.0 +1106 2.95 3.35 11.25 -231.405 35.127 231.405 3026.44 -35.127 -3026.44 0.0 +1107 2.95 3.35 18.75 -89.8146 -2.33149 89.8146 930.13 2.3315 -930.13 0.0 +1108 2.95 3.35 26.25 -22.0607 -7.1465 22.0607 211.828 7.14652 -211.828 0.0 +1109 2.95 3.35 33.75 -2.61211 -2.84669 2.61203 30.3988 2.84678 -30.3988 0.0 +1110 2.95 3.35 41.25 -0.0641668 -0.572722 0.0641482 1.85321 0.572769 -1.85319 0.0 +1111 2.95 3.35 48.75 -0.0727144 -0.324155 0.0726592 -0.0128306 0.324113 0.0128188 0.0 +1112 2.95 3.35 56.25 -0.0429539 -0.369477 0.0429431 0.0365148 0.369487 -0.0365382 0.0 +1113 2.95 3.35 63.75 -0.0600198 -0.322362 0.0600919 0.0327313 0.322318 -0.0327163 0.0 +1114 2.95 3.35 71.25 -0.0652833 -0.262303 0.0652719 -0.000945077 0.262315 0.000937457 0.0 +1115 2.95 3.35 78.75 -0.031022 -0.194374 0.0309769 -0.0267122 0.194554 0.0267582 0.0 +1116 2.95 3.35 86.25 -0.00184005 -0.113162 0.00176104 -0.0298197 0.113076 0.0298218 0.0 +1117 2.95 3.35 93.75 0.018586 -0.0277066 -0.0184827 -0.0312711 0.0276271 0.0312812 0.0 +1118 2.95 3.35 101.25 0.0371138 0.0478631 -0.037144 -0.0299553 -0.0480008 0.0299616 0.0 +1119 2.95 3.35 108.75 0.0423982 0.093388 -0.0422422 -0.0188882 -0.0933397 0.0188857 0.0 +1120 2.95 3.35 116.25 0.0273758 0.0979945 -0.0273687 -0.00448478 -0.0979721 0.00447213 0.0 +1121 2.95 3.35 123.75 0.00420771 0.0743592 -0.00427898 0.00600864 -0.0745728 -0.0058675 0.0 +1122 2.95 3.35 131.25 -0.0145851 0.0414175 0.0147362 0.0124371 -0.0414414 -0.0124358 0.0 +1123 2.95 3.35 138.75 -0.03007 0.00528296 0.0300369 0.0181261 -0.00525075 -0.018187 0.0 +1124 2.95 3.35 146.25 -0.0509356 -0.0404972 0.0512567 0.0264418 0.040464 -0.0264103 0.0 +1125 2.95 3.35 153.75 -0.0853645 -0.10106 0.0852954 0.0392425 0.100971 -0.0391701 0.0 +1126 2.95 3.35 161.25 -0.129326 -0.170331 0.12924 0.0554642 0.170326 -0.0554588 0.0 +1127 2.95 3.35 168.75 -0.171342 -0.232151 0.171081 0.0709676 0.232288 -0.0710617 0.0 +1128 2.95 3.35 176.25 -0.196671 -0.268622 0.196769 0.0804998 0.268617 -0.0804939 0.0 +1129 2.95 3.45 3.75 -118.47 124.094 118.47 3596.85 -124.094 -3596.85 0.0 +1130 2.95 3.45 11.25 -62.0251 58.1208 62.0251 1612.69 -58.1208 -1612.69 0.0 +1131 2.95 3.45 18.75 -17.2025 11.8124 17.2025 506.519 -11.8125 -506.519 0.0 +1132 2.95 3.45 26.25 -0.377844 -1.71658 0.37789 113.34 1.71654 -113.34 0.0 +1133 2.95 3.45 33.75 1.37632 -1.48954 -1.37633 15.5555 1.4896 -15.5555 0.0 +1134 2.95 3.45 41.25 0.265026 -0.272138 -0.265013 0.865629 0.272128 -0.865594 0.0 +1135 2.95 3.45 48.75 -0.0675124 -0.169675 0.0675642 -0.0146368 0.169647 0.0146363 0.0 +1136 2.95 3.45 56.25 -0.023388 -0.236641 0.0234179 0.015066 0.236607 -0.015018 0.0 +1137 2.95 3.45 63.75 -0.0206674 -0.214642 0.0205493 0.0137967 0.214624 -0.0137863 0.0 +1138 2.95 3.45 71.25 -0.0266153 -0.192791 0.0266153 -0.00202341 0.192818 0.00206841 0.0 +1139 2.95 3.45 78.75 -0.01303 -0.158177 0.0130391 -0.00963045 0.158217 0.00964696 0.0 +1140 2.95 3.45 86.25 -0.00222429 -0.0960735 0.0021395 -0.0105039 0.0961189 0.0105017 0.0 +1141 2.95 3.45 93.75 0.00366176 -0.0280042 -0.00362622 -0.0130186 0.0279556 0.0130227 0.0 +1142 2.95 3.45 101.25 0.0105055 0.0297138 -0.0104632 -0.0119289 -0.0296664 0.0119117 0.0 +1143 2.95 3.45 108.75 0.0148087 0.0656952 -0.0147408 -0.00665645 -0.0657398 0.0066868 0.0 +1144 2.95 3.45 116.25 0.0114932 0.0726041 -0.0116021 -0.00156607 -0.0726457 0.00154858 0.0 +1145 2.95 3.45 123.75 0.00309518 0.0572911 -0.00312058 0.00244903 -0.0572973 -0.00247607 0.0 +1146 2.95 3.45 131.25 -0.00423195 0.0348253 0.00428653 0.0058355 -0.0347892 -0.0058315 0.0 +1147 2.95 3.45 138.75 -0.00866474 0.0124609 0.00861874 0.00825108 -0.0125166 -0.00826851 0.0 +1148 2.95 3.45 146.25 -0.0145607 -0.0144555 0.0146647 0.0107256 0.0144883 -0.0106962 0.0 +1149 2.95 3.45 153.75 -0.0287837 -0.0532811 0.0286297 0.0157047 0.0531415 -0.0156193 0.0 +1150 2.95 3.45 161.25 -0.0515253 -0.102148 0.0515477 0.0240732 0.102183 -0.0241063 0.0 +1151 2.95 3.45 168.75 -0.0767337 -0.148935 0.0767439 0.0334601 0.1489 -0.0334712 0.0 +1152 2.95 3.45 176.25 -0.0932086 -0.17774 0.0931942 0.0396944 0.177763 -0.0397001 0.0 +1153 2.95 3.55 3.75 9.21891 55.9716 -9.21891 1053.07 -55.9716 -1053.07 0.0 +1154 2.95 3.55 11.25 12.0915 26.8507 -12.0915 505.759 -26.8507 -505.759 0.0 +1155 2.95 3.55 18.75 10.5932 5.25111 -10.5932 161.202 -5.25111 -161.202 0.0 +1156 2.95 3.55 26.25 5.832 -0.960922 -5.83198 35.2215 0.960912 -35.2215 0.0 +1157 2.95 3.55 33.75 1.90632 -0.606111 -1.90629 4.63776 0.606103 -4.63776 0.0 +1158 2.95 3.55 41.25 0.243995 0.00564805 -0.243998 0.296232 -0.00567539 -0.296199 0.0 +1159 2.95 3.55 48.75 -0.0591471 -0.00860415 0.0591375 0.0274887 0.00861739 -0.0274844 0.0 +1160 2.95 3.55 56.25 -0.0269926 -0.0691277 0.0269968 0.0114055 0.0691244 -0.0114149 0.0 +1161 2.95 3.55 63.75 -0.00607235 -0.0689444 0.00606736 0.00520628 0.0689476 -0.00519972 0.0 +1162 2.95 3.55 71.25 -0.00320545 -0.0714308 0.00319651 0.00162512 0.0714338 -0.00162543 0.0 +1163 2.95 3.55 78.75 -0.000709974 -0.0611886 0.00068591 -0.000332506 0.0611933 0.00033069 0.0 +1164 2.95 3.55 86.25 -0.00172169 -0.0350745 0.00168824 -0.00153632 0.035038 0.00153626 0.0 +1165 2.95 3.55 93.75 -0.00504304 -0.0114154 0.00501691 -0.001532 0.0114067 0.0015284 0.0 +1166 2.95 3.55 101.25 -0.00419399 0.00690274 0.00423812 -0.00070908 -0.00693605 0.000712363 0.0 +1167 2.95 3.55 108.75 0.00145246 0.0217666 -0.00146955 -0.00136473 -0.0217677 0.00136709 0.0 +1168 2.95 3.55 116.25 0.00646822 0.0283925 -0.00648991 -0.0023095 -0.0283929 0.00231683 0.0 +1169 2.95 3.55 123.75 0.0071676 0.0255024 -0.00717304 -0.00117394 -0.0255343 0.00118872 0.0 +1170 2.95 3.55 131.25 0.00551051 0.0191405 -0.00553503 0.000805702 -0.0191302 -0.000807014 0.0 +1171 2.95 3.55 138.75 0.00491972 0.0139924 -0.00492367 0.00107791 -0.0140157 -0.00107725 0.0 +1172 2.95 3.55 146.25 0.00468329 0.0079675 -0.00466349 9.16014e-06 -0.0079586 -7.70033e-06 0.0 +1173 2.95 3.55 153.75 0.00109992 -0.00389049 -0.00104878 0.000299902 0.00394253 -0.000326509 0.0 +1174 2.95 3.55 161.25 -0.0078958 -0.022461 0.00792024 0.0035239 0.0224411 -0.0035224 0.0 +1175 2.95 3.55 168.75 -0.019444 -0.0423078 0.0194506 0.00839838 0.0423256 -0.00840352 0.0 +1176 2.95 3.55 176.25 -0.0275442 -0.0551633 0.0275625 0.011971 0.0551683 -0.0119705 0.0 +1177 2.95 3.65 3.75 7.06704 4.57331 -7.06704 82.2836 -4.57331 -82.2836 0.0 +1178 2.95 3.65 11.25 5.4451 1.75617 -5.4451 41.4025 -1.75617 -41.4025 0.0 +1179 2.95 3.65 18.75 3.205 -0.181937 -3.205 13.315 0.181936 -13.315 0.0 +1180 2.95 3.65 26.25 1.3884 -0.45091 -1.3884 2.87287 0.450911 -2.87287 0.0 +1181 2.95 3.65 33.75 0.399535 -0.156162 -0.399534 0.408566 0.156164 -0.408568 0.0 +1182 2.95 3.65 41.25 0.0474327 0.000325414 -0.0474365 0.0559439 -0.000322232 -0.0559436 0.0 +1183 2.95 3.65 48.75 -0.0167623 0.0148239 0.0167622 0.0118571 -0.0148242 -0.011857 0.0 +1184 2.95 3.65 56.25 -0.00966538 0.00961204 0.00966566 0.000613902 -0.00961345 -0.000615629 0.0 +1185 2.95 3.65 63.75 -0.0018771 0.00670523 0.00187471 0.000440809 -0.00670146 -0.000440008 0.0 +1186 2.95 3.65 71.25 -0.000281351 0.00228719 0.000284629 0.00150972 -0.00228777 -0.00150899 0.0 +1187 2.95 3.65 78.75 -0.000573671 0.000786642 0.000576419 0.00114584 -0.000789663 -0.00114555 0.0 +1188 2.95 3.65 86.25 -0.00114618 0.000614687 0.00115016 0.000658531 -0.000610215 -0.000658224 0.0 +1189 2.95 3.65 93.75 -0.0014843 -0.00108906 0.00148416 0.000686066 0.00108644 -0.000685896 0.0 +1190 2.95 3.65 101.25 -0.000744824 -0.00226437 0.000742569 0.000394 0.00226277 -0.000394553 0.0 +1191 2.95 3.65 108.75 0.000733179 -0.00144773 -0.000733097 -0.000392875 0.00144773 0.000393178 0.0 +1192 2.95 3.65 116.25 0.00137293 -0.00049035 -0.00137606 -0.000632154 0.000487911 0.000633826 0.0 +1193 2.95 3.65 123.75 0.000493895 -0.000912215 -0.00049636 8.38473e-05 0.000900696 -7.85158e-05 0.0 +1194 2.95 3.65 131.25 -0.000825425 -0.0018564 0.000824058 0.000856545 0.00185558 -0.000856062 0.0 +1195 2.95 3.65 138.75 -0.00108814 -0.00180504 0.00109441 0.000819354 0.00179515 -0.000812508 0.0 +1196 2.95 3.65 146.25 1.93775e-05 -0.000479276 -1.65839e-05 0.000158438 0.000470583 -0.000154836 0.0 +1197 2.95 3.65 153.75 0.00166473 0.00127079 -0.00166242 -0.000315957 -0.00126902 0.00031561 0.0 +1198 2.95 3.65 161.25 0.00284097 0.00252966 -0.00283858 -0.000108367 -0.00252762 0.000107593 0.0 +1199 2.95 3.65 168.75 0.00323364 0.00305014 -0.00322845 0.000583253 -0.00304442 -0.000587227 0.0 +1200 2.95 3.65 176.25 0.00320119 0.00313431 -0.00320683 0.0011639 -0.00314025 -0.00116103 0.0 +1201 3.05 3.05 3.75 -1202.39 -470.365 1202.39 24403 470.365 -24403 0.0 +1202 3.05 3.05 11.25 -668.169 -316.378 668.169 5239.8 316.378 -5239.8 0.0 +1203 3.05 3.05 18.75 -281.731 -159.304 281.731 1455.24 159.304 -1455.24 0.0 +1204 3.05 3.05 26.25 -82.2316 -55.9751 82.2316 322.339 55.9751 -322.339 0.0 +1205 3.05 3.05 33.75 -13.2072 -11.7376 13.2072 43.2474 11.7377 -43.2475 0.0 +1206 3.05 3.05 41.25 -0.23727 -0.951403 0.237225 1.56363 0.951413 -1.56361 0.0 +1207 3.05 3.05 48.75 -0.165939 -0.246228 0.165967 0.206541 0.24613 -0.206511 0.0 +1208 3.05 3.05 56.25 -0.436043 -0.410636 0.436083 0.304896 0.410632 -0.304963 0.0 +1209 3.05 3.05 63.75 -0.30763 -0.310295 0.307609 0.0679989 0.310281 -0.0680052 0.0 +1210 3.05 3.05 71.25 -0.206649 -0.205757 0.206684 -0.0143256 0.20578 0.0143312 0.0 +1211 3.05 3.05 78.75 -0.11617 -0.112842 0.116269 -0.0611922 0.112662 0.0611357 0.0 +1212 3.05 3.05 86.25 -0.029379 -0.026893 0.0293335 -0.0825493 0.0270606 0.0825471 0.0 +1213 3.05 3.05 93.75 0.0356369 0.0385347 -0.0355095 -0.077343 -0.0385093 0.0773448 0.0 +1214 3.05 3.05 101.25 0.0825754 0.0864857 -0.0826079 -0.0638125 -0.0866197 0.0638187 0.0 +1215 3.05 3.05 108.75 0.102049 0.105697 -0.102052 -0.0415323 -0.105879 0.0415234 0.0 +1216 3.05 3.05 116.25 0.0810613 0.0846985 -0.0811354 -0.00976694 -0.0847927 0.00982253 0.0 +1217 3.05 3.05 123.75 0.0328587 0.0382796 -0.0327086 0.0205591 -0.0383158 -0.0204996 0.0 +1218 3.05 3.05 131.25 -0.0175676 -0.00884341 0.0174819 0.0399706 0.00881225 -0.0399405 0.0 +1219 3.05 3.05 138.75 -0.0618523 -0.0507538 0.0617807 0.050519 0.0510671 -0.0507029 0.0 +1220 3.05 3.05 146.25 -0.112984 -0.102557 0.112876 0.062213 0.102547 -0.0622186 0.0 +1221 3.05 3.05 153.75 -0.183953 -0.177566 0.184157 0.0833769 0.177745 -0.0834765 0.0 +1222 3.05 3.05 161.25 -0.271208 -0.270479 0.271245 0.113891 0.27054 -0.113888 0.0 +1223 3.05 3.05 168.75 -0.353042 -0.357989 0.353053 0.145016 0.357905 -0.145054 0.0 +1224 3.05 3.05 176.25 -0.402759 -0.411064 0.402707 0.164734 0.411172 -0.164821 0.0 +1225 3.05 3.15 3.75 -1005.86 -194.498 1005.86 20622.3 194.498 -20622.3 0.0 +1226 3.05 3.15 11.25 -566.091 -160.869 566.091 4886.81 160.869 -4886.81 0.0 +1227 3.05 3.15 18.75 -240.287 -91.2699 240.287 1363.35 91.2699 -1363.35 0.0 +1228 3.05 3.15 26.25 -72.1732 -33.8748 72.1732 302.315 33.8748 -302.315 0.0 +1229 3.05 3.15 33.75 -13.3946 -6.76814 13.3946 41.8615 6.76815 -41.8615 0.0 +1230 3.05 3.15 41.25 -1.23842 -0.233142 1.2384 2.17485 0.233108 -2.17487 0.0 +1231 3.05 3.15 48.75 -0.292521 -0.178012 0.292534 0.218004 0.177961 -0.217937 0.0 +1232 3.05 3.15 56.25 -0.284809 -0.428332 0.284868 0.232091 0.428389 -0.232079 0.0 +1233 3.05 3.15 63.75 -0.220727 -0.340585 0.220826 0.0743496 0.340452 -0.0743638 0.0 +1234 3.05 3.15 71.25 -0.169662 -0.229028 0.169575 -0.00422416 0.228937 0.00423996 0.0 +1235 3.05 3.15 78.75 -0.0951492 -0.138864 0.0951079 -0.0524268 0.138897 0.0524133 0.0 +1236 3.05 3.15 86.25 -0.0249568 -0.057734 0.0249618 -0.0648182 0.0578461 0.0648357 0.0 +1237 3.05 3.15 93.75 0.0258392 0.0131362 -0.0256859 -0.0587348 -0.0128765 0.058722 0.0 +1238 3.05 3.15 101.25 0.0643498 0.0683206 -0.0643807 -0.0481836 -0.0685476 0.0481991 0.0 +1239 3.05 3.15 108.75 0.0794928 0.0928215 -0.0794856 -0.02838 -0.0927884 0.0283377 0.0 +1240 3.05 3.15 116.25 0.0621262 0.0783423 -0.0619376 -0.00193475 -0.0783081 0.00196418 0.0 +1241 3.05 3.15 123.75 0.0258006 0.041661 -0.0259602 0.0203971 -0.0415221 -0.0204713 0.0 +1242 3.05 3.15 131.25 -0.00984299 0.0033761 0.0098454 0.0334746 -0.00365493 -0.0333855 0.0 +1243 3.05 3.15 138.75 -0.0442769 -0.0350514 0.0443307 0.0414554 0.0352449 -0.041497 0.0 +1244 3.05 3.15 146.25 -0.091463 -0.0871559 0.0914155 0.052571 0.0871283 -0.0525267 0.0 +1245 3.05 3.15 153.75 -0.160353 -0.160828 0.160224 0.0723048 0.160761 -0.0723438 0.0 +1246 3.05 3.15 161.25 -0.243335 -0.247674 0.243164 0.0993507 0.247967 -0.0995663 0.0 +1247 3.05 3.15 168.75 -0.318898 -0.326134 0.319007 0.126072 0.32627 -0.126173 0.0 +1248 3.05 3.15 176.25 -0.36419 -0.372832 0.36427 0.142724 0.372732 -0.142595 0.0 +1249 3.05 3.25 3.75 -707.917 46.1555 707.917 14705.3 -46.1555 -14705.3 0.0 +1250 3.05 3.25 11.25 -403.239 -21.7092 403.239 4225.41 21.7092 -4225.41 0.0 +1251 3.05 3.25 18.75 -168.322 -33.4945 168.322 1198.15 33.4945 -1198.15 0.0 +1252 3.05 3.25 26.25 -49.4611 -17.619 49.4611 265.09 17.619 -265.09 0.0 +1253 3.05 3.25 33.75 -9.19503 -4.34197 9.19508 37.0193 4.34196 -37.0193 0.0 +1254 3.05 3.25 41.25 -0.984275 -0.283052 0.984305 2.13686 0.283053 -2.13689 0.0 +1255 3.05 3.25 48.75 -0.18842 -0.24192 0.188469 0.12944 0.241853 -0.129426 0.0 +1256 3.05 3.25 56.25 -0.14452 -0.42971 0.144635 0.148393 0.42977 -0.148431 0.0 +1257 3.05 3.25 63.75 -0.142141 -0.341575 0.142225 0.0603106 0.341607 -0.0603114 0.0 +1258 3.05 3.25 71.25 -0.120366 -0.235824 0.120331 -0.00584193 0.236031 0.00590595 0.0 +1259 3.05 3.25 78.75 -0.0648858 -0.155118 0.0648497 -0.0407089 0.155197 0.0406872 0.0 +1260 3.05 3.25 86.25 -0.0170367 -0.0778598 0.0169629 -0.0444295 0.0780579 0.0444343 0.0 +1261 3.05 3.25 93.75 0.0177195 -0.00503444 -0.0176269 -0.0424893 0.00514769 0.042496 0.0 +1262 3.05 3.25 101.25 0.0462891 0.05416 -0.0462865 -0.0373615 -0.0542229 0.0373631 0.0 +1263 3.05 3.25 108.75 0.0573669 0.084333 -0.0573216 -0.0224864 -0.0844456 0.0224838 0.0 +1264 3.05 3.25 116.25 0.0451776 0.0795648 -0.0451227 -0.00389795 -0.0795657 0.00392705 0.0 +1265 3.05 3.25 123.75 0.0215897 0.0526945 -0.021368 0.0103573 -0.0529347 -0.010223 0.0 +1266 3.05 3.25 131.25 -0.00169711 0.0202141 0.00167047 0.0191787 -0.0203379 -0.0191286 0.0 +1267 3.05 3.25 138.75 -0.0264021 -0.0159575 0.0263373 0.0263274 0.0160538 -0.0263645 0.0 +1268 3.05 3.25 146.25 -0.0639974 -0.0644796 0.063985 0.0366322 0.0642138 -0.0364741 0.0 +1269 3.05 3.25 153.75 -0.119886 -0.129575 0.119896 0.0530471 0.129703 -0.0531036 0.0 +1270 3.05 3.25 161.25 -0.186549 -0.203618 0.186351 0.0742664 0.20364 -0.0742798 0.0 +1271 3.05 3.25 168.75 -0.246276 -0.269152 0.246288 0.0946959 0.269294 -0.0948405 0.0 +1272 3.05 3.25 176.25 -0.281602 -0.307458 0.281688 0.107277 0.307531 -0.107285 0.0 +1273 3.05 3.35 3.75 -365.113 209.441 365.113 9554.04 -209.441 -9554.04 0.0 +1274 3.05 3.35 11.25 -204.246 81.0767 204.246 3280.1 -81.0766 -3280.1 0.0 +1275 3.05 3.35 18.75 -79.3542 9.6114 79.3542 951.267 -9.61141 -951.267 0.0 +1276 3.05 3.35 26.25 -20.8335 -5.94072 20.8335 209.249 5.9407 -209.249 0.0 +1277 3.05 3.35 33.75 -3.39742 -2.81825 3.39744 28.9771 2.81824 -28.9771 0.0 +1278 3.05 3.35 41.25 -0.403877 -0.37604 0.403872 1.67216 0.375997 -1.67217 0.0 +1279 3.05 3.35 48.75 -0.0863015 -0.268756 0.0862503 0.0304183 0.2687 -0.0303612 0.0 +1280 3.05 3.35 56.25 -0.0467076 -0.385723 0.0467254 0.0764897 0.385756 -0.0765678 0.0 +1281 3.05 3.35 63.75 -0.0765137 -0.296157 0.076492 0.0332949 0.296254 -0.033302 0.0 +1282 3.05 3.35 71.25 -0.0737102 -0.217777 0.0736319 -0.011919 0.217711 0.0118976 0.0 +1283 3.05 3.35 78.75 -0.0386226 -0.164005 0.0385937 -0.0252131 0.164091 0.0252167 0.0 +1284 3.05 3.35 86.25 -0.00860859 -0.0968502 0.00848829 -0.0245854 0.0969682 0.0245984 0.0 +1285 3.05 3.35 93.75 0.0147737 -0.0236231 -0.0147163 -0.0288229 0.0237517 0.0288162 0.0 +1286 3.05 3.35 101.25 0.0330742 0.0394288 -0.0329504 -0.0272844 -0.0394857 0.0273121 0.0 +1287 3.05 3.35 108.75 0.0377886 0.0770313 -0.0378089 -0.0166062 -0.0771797 0.0166531 0.0 +1288 3.05 3.35 116.25 0.0269164 0.0808568 -0.0269524 -0.00526022 -0.0808528 0.00523792 0.0 +1289 3.05 3.35 123.75 0.00994602 0.0605897 -0.00992017 0.00301009 -0.06072 -0.00291031 0.0 +1290 3.05 3.35 131.25 -0.00533206 0.0321631 0.00513532 0.00937287 -0.0322053 -0.00941624 0.0 +1291 3.05 3.35 138.75 -0.0198079 0.00170782 0.0198683 0.0152825 -0.00186433 -0.0152538 0.0 +1292 3.05 3.35 146.25 -0.0421542 -0.0369206 0.0421364 0.0228346 0.0366588 -0.0227076 0.0 +1293 3.05 3.35 153.75 -0.0772172 -0.0895244 0.0772434 0.0344402 0.0896002 -0.0344561 0.0 +1294 3.05 3.35 161.25 -0.121604 -0.151599 0.12161 0.0498996 0.151602 -0.0499331 0.0 +1295 3.05 3.35 168.75 -0.163376 -0.208149 0.163288 0.0652244 0.208133 -0.0652161 0.0 +1296 3.05 3.35 176.25 -0.188553 -0.242014 0.18862 0.0748184 0.241996 -0.0748296 0.0 +1297 3.05 3.45 3.75 -49.0063 211.636 49.0063 4534.02 -211.636 -4534.02 0.0 +1298 3.05 3.45 11.25 -16.2879 99.9048 16.2879 1783.56 -99.9048 -1783.56 0.0 +1299 3.05 3.45 18.75 1.92371 24.1588 -1.92369 528.913 -24.1588 -528.913 0.0 +1300 3.05 3.45 26.25 3.92081 0.239734 -3.92085 114.895 -0.239708 -114.895 0.0 +1301 3.05 3.45 33.75 1.33681 -1.29813 -1.33683 15.4468 1.29814 -15.4467 0.0 +1302 3.05 3.45 41.25 0.0515692 -0.168192 -0.0515773 0.808296 0.168187 -0.808324 0.0 +1303 3.05 3.45 48.75 -0.0454932 -0.172325 0.0455576 -0.0119284 0.172203 0.0119136 0.0 +1304 3.05 3.45 56.25 -0.00725921 -0.261217 0.00720111 0.0402311 0.261254 -0.040187 0.0 +1305 3.05 3.45 63.75 -0.0304125 -0.195611 0.0304302 0.0163773 0.195633 -0.0163835 0.0 +1306 3.05 3.45 71.25 -0.0332991 -0.159008 0.0333114 -0.00806962 0.159016 0.00804613 0.0 +1307 3.05 3.45 78.75 -0.0178735 -0.133654 0.0179131 -0.00824974 0.13361 0.00825353 0.0 +1308 3.05 3.45 86.25 -0.00502976 -0.0823886 0.00511234 -0.00794398 0.0823682 0.00794143 0.0 +1309 3.05 3.45 93.75 0.00414406 -0.0240697 -0.00419551 -0.0119802 0.0240974 0.0119811 0.0 +1310 3.05 3.45 101.25 0.0110567 0.0255518 -0.0111244 -0.0104323 -0.025573 0.0104402 0.0 +1311 3.05 3.45 108.75 0.0138462 0.0574772 -0.013883 -0.00606324 -0.0575893 0.00608259 0.0 +1312 3.05 3.45 116.25 0.011077 0.0635865 -0.0110606 -0.00305434 -0.0635874 0.00307944 0.0 +1313 3.05 3.45 123.75 0.00449426 0.0488256 -0.00448388 0.000439858 -0.0487677 -0.000429246 0.0 +1314 3.05 3.45 131.25 -0.0019067 0.0282409 0.0019165 0.0047807 -0.028183 -0.00479583 0.0 +1315 3.05 3.45 138.75 -0.00725526 0.00817585 0.0071253 0.00823976 -0.0082291 -0.00826636 0.0 +1316 3.05 3.45 146.25 -0.0164527 -0.017166 0.0163605 0.0119186 0.0170814 -0.0118721 0.0 +1317 3.05 3.45 153.75 -0.0355769 -0.0560084 0.0355731 0.0191433 0.0558956 -0.0190579 0.0 +1318 3.05 3.45 161.25 -0.0646594 -0.106219 0.0647645 0.0307881 0.106203 -0.0308022 0.0 +1319 3.05 3.45 168.75 -0.0953586 -0.154516 0.0954731 0.0434057 0.154565 -0.0434184 0.0 +1320 3.05 3.45 176.25 -0.115325 -0.184291 0.11528 0.0516029 0.184203 -0.0515372 0.0 +1321 3.05 3.55 3.75 58.2865 95.694 -58.2865 1303.18 -95.694 -1303.18 0.0 +1322 3.05 3.55 11.25 43.7842 47.0725 -43.7842 564.702 -47.0725 -564.702 0.0 +1323 3.05 3.55 18.75 24.1468 11.6001 -24.1468 170.104 -11.6002 -170.104 0.0 +1324 3.05 3.55 26.25 9.2032 0.165595 -9.2032 36.0656 -0.165608 -36.0656 0.0 +1325 3.05 3.55 33.75 2.10018 -0.495089 -2.10018 4.59251 0.495098 -4.5925 0.0 +1326 3.05 3.55 41.25 0.159888 0.0314295 -0.159875 0.213805 -0.0314347 -0.213825 0.0 +1327 3.05 3.55 48.75 -0.0316332 -0.0209589 0.0316297 0.0113881 0.020965 -0.011392 0.0 +1328 3.05 3.55 56.25 -0.00590874 -0.08247 0.00589294 0.029912 0.0824799 -0.0299018 0.0 +1329 3.05 3.55 63.75 -0.00460387 -0.0639712 0.00458972 0.0134455 0.0639916 -0.0134371 0.0 +1330 3.05 3.55 71.25 -0.00323754 -0.0605657 0.00327371 0.00123371 0.0605309 -0.00124148 0.0 +1331 3.05 3.55 78.75 -0.000975075 -0.0526099 0.000959984 0.00021812 0.052629 -0.000218025 0.0 +1332 3.05 3.55 86.25 -0.00152766 -0.0304211 0.00152531 -0.000124893 0.0304344 0.000128979 0.0 +1333 3.05 3.55 93.75 -0.00281045 -0.0103052 0.00282543 -0.000164696 0.0103138 0.000165631 0.0 +1334 3.05 3.55 101.25 -0.000794283 0.00655645 0.00082915 9.05452e-05 -0.0065146 -9.18973e-05 0.0 +1335 3.05 3.55 108.75 0.0048571 0.0208882 -0.00483972 -0.00172205 -0.020898 0.00171912 0.0 +1336 3.05 3.55 116.25 0.00910593 0.0261263 -0.00910381 -0.00286916 -0.026165 0.00289949 0.0 +1337 3.05 3.55 123.75 0.00835341 0.0213906 -0.00837047 -0.000577344 -0.0213633 0.000556754 0.0 +1338 3.05 3.55 131.25 0.00484672 0.0140179 -0.00483896 0.00261085 -0.0140112 -0.00259889 0.0 +1339 3.05 3.55 138.75 0.00145793 0.00803444 -0.00146708 0.00365082 -0.00802698 -0.00365445 0.0 +1340 3.05 3.55 146.25 -0.00319952 -0.000185068 0.00323208 0.00391313 0.000156672 -0.00387595 0.0 +1341 3.05 3.55 153.75 -0.0136071 -0.0160629 0.0136006 0.0069895 0.0160638 -0.00699597 0.0 +1342 3.05 3.55 161.25 -0.0307544 -0.0391932 0.0307909 0.0140586 0.0392269 -0.0140635 0.0 +1343 3.05 3.55 168.75 -0.0498663 -0.0628118 0.0498782 0.0225481 0.0628021 -0.0225421 0.0 +1344 3.05 3.55 176.25 -0.0625385 -0.0776921 0.0625437 0.0282624 0.0776849 -0.0282597 0.0 +1345 3.05 3.65 3.75 14.7738 9.01288 -14.7738 99.4234 -9.01288 -99.4234 0.0 +1346 3.05 3.65 11.25 10.4256 4.10096 -10.4256 45.9297 -4.10096 -45.9297 0.0 +1347 3.05 3.65 18.75 5.33829 0.564282 -5.33829 13.8766 -0.564281 -13.8766 0.0 +1348 3.05 3.65 26.25 1.92055 -0.318539 -1.92055 2.83407 0.318537 -2.83407 0.0 +1349 3.05 3.65 33.75 0.431842 -0.140656 -0.431843 0.348739 0.140656 -0.348739 0.0 +1350 3.05 3.65 41.25 0.0364247 0.00723669 -0.0364242 0.0264389 -0.00723644 -0.0264393 0.0 +1351 3.05 3.65 48.75 -0.0100345 0.0159315 0.0100318 0.0080024 -0.0159293 -0.00800035 0.0 +1352 3.05 3.65 56.25 -0.00452025 0.00778732 0.00451941 0.00551883 -0.00778686 -0.00552083 0.0 +1353 3.05 3.65 63.75 -0.000672337 0.00521555 0.000670408 0.00280248 -0.00521397 -0.00280318 0.0 +1354 3.05 3.65 71.25 0.000360923 0.00171355 -0.00036216 0.00121365 -0.00171269 -0.00121435 0.0 +1355 3.05 3.65 78.75 6.70805e-05 0.000819412 -6.59271e-05 0.000597606 -0.000817676 -0.000597435 0.0 +1356 3.05 3.65 86.25 -0.00057186 0.000644185 0.000572355 0.000567504 -0.00064307 -0.000567647 0.0 +1357 3.05 3.65 93.75 -0.000751471 -0.00106817 0.000749874 0.000757072 0.00106639 -0.000757055 0.0 +1358 3.05 3.65 101.25 0.000275919 -0.00183009 -0.000275096 0.000255174 0.00183474 -0.00025562 0.0 +1359 3.05 3.65 108.75 0.00189848 -0.000761837 -0.00189497 -0.000636546 0.000759074 0.000637236 0.0 +1360 3.05 3.65 116.25 0.00236351 -0.000115402 -0.00236272 -0.000553323 0.000119324 0.000553044 0.0 +1361 3.05 3.65 123.75 0.00106135 -0.00107726 -0.00106142 0.000592741 0.00108013 -0.000595129 0.0 +1362 3.05 3.65 131.25 -0.000675214 -0.0023987 0.000676951 0.00145629 0.00239971 -0.00145617 0.0 +1363 3.05 3.65 138.75 -0.00134281 -0.00270273 0.00134522 0.00120903 0.00269853 -0.00120659 0.0 +1364 3.05 3.65 146.25 -0.000900174 -0.00203273 0.000901187 0.000435489 0.00203583 -0.00043519 0.0 +1365 3.05 3.65 153.75 -0.000477871 -0.00132233 0.00047692 0.000219008 0.00131769 -0.000216421 0.0 +1366 3.05 3.65 161.25 -0.000970611 -0.00119912 0.000968838 0.000989395 0.00120357 -0.000993014 0.0 +1367 3.05 3.65 168.75 -0.00221265 -0.00158211 0.00221741 0.00227827 0.00158658 -0.00228145 0.0 +1368 3.05 3.65 176.25 -0.00325813 -0.00197769 0.00326165 0.00322864 0.00198236 -0.00323014 0.0 +1369 3.15 3.15 3.75 -956.411 -157.961 956.411 21490.2 157.961 -21490.2 0.0 +1370 3.15 3.15 11.25 -539.133 -158.376 539.133 4570.6 158.376 -4570.6 0.0 +1371 3.15 3.15 18.75 -230.746 -100.448 230.746 1239.08 100.448 -1239.08 0.0 +1372 3.15 3.15 26.25 -69.0286 -41.453 69.0285 264.322 41.4531 -264.322 0.0 +1373 3.15 3.15 33.75 -11.9443 -9.95787 11.9443 34.0693 9.95793 -34.0693 0.0 +1374 3.15 3.15 41.25 -0.582646 -0.953585 0.58261 1.49815 0.953585 -1.49815 0.0 +1375 3.15 3.15 48.75 -0.185725 -0.189058 0.185672 0.262739 0.188971 -0.262688 0.0 +1376 3.15 3.15 56.25 -0.35028 -0.339487 0.350287 0.209512 0.33955 -0.209522 0.0 +1377 3.15 3.15 63.75 -0.251984 -0.259721 0.252092 0.053384 0.25962 -0.0533321 0.0 +1378 3.15 3.15 71.25 -0.171035 -0.17401 0.170979 -0.00382131 0.173971 0.003789 0.0 +1379 3.15 3.15 78.75 -0.103081 -0.108356 0.103106 -0.0377398 0.108153 0.0377189 0.0 +1380 3.15 3.15 86.25 -0.0427632 -0.046394 0.0427713 -0.0466376 0.0463966 0.046639 0.0 +1381 3.15 3.15 93.75 0.00566927 0.00495154 -0.00569908 -0.0428492 -0.00499621 0.0428512 0.0 +1382 3.15 3.15 101.25 0.0504745 0.0463917 -0.0505543 -0.0360707 -0.0464682 0.0360915 0.0 +1383 3.15 3.15 108.75 0.0794281 0.0686813 -0.0795551 -0.0228925 -0.0688457 0.0229235 0.0 +1384 3.15 3.15 116.25 0.0742594 0.061464 -0.0741882 -0.00450275 -0.0615471 0.00449575 0.0 +1385 3.15 3.15 123.75 0.0412054 0.0335455 -0.0410459 0.0122873 -0.0334909 -0.0122658 0.0 +1386 3.15 3.15 131.25 0.00256192 0.00204886 -0.00232937 0.0225283 -0.00204045 -0.0224878 0.0 +1387 3.15 3.15 138.75 -0.0317873 -0.0281822 0.0319935 0.0275685 0.0282669 -0.0275469 0.0 +1388 3.15 3.15 146.25 -0.0711984 -0.0672197 0.0711102 0.0343857 0.0670901 -0.0343675 0.0 +1389 3.15 3.15 153.75 -0.126399 -0.123952 0.126399 0.0498039 0.123889 -0.049802 0.0 +1390 3.15 3.15 161.25 -0.195704 -0.194707 0.195608 0.074158 0.194762 -0.0742025 0.0 +1391 3.15 3.15 168.75 -0.261579 -0.261942 0.261393 0.100026 0.261901 -0.100036 0.0 +1392 3.15 3.15 176.25 -0.301524 -0.302836 0.301604 0.116713 0.302746 -0.116682 0.0 +1393 3.15 3.25 3.75 -650.193 134.226 650.193 17650.1 -134.226 -17650.1 0.0 +1394 3.15 3.25 11.25 -365.979 7.48146 365.979 4109.37 -7.48145 -4109.37 0.0 +1395 3.15 3.25 18.75 -155.208 -30.119 155.208 1115.3 30.119 -1115.3 0.0 +1396 3.15 3.25 26.25 -46.6783 -20.0797 46.6784 237.228 20.0796 -237.228 0.0 +1397 3.15 3.25 33.75 -8.72374 -5.70064 8.7238 31.186 5.70056 -31.186 0.0 +1398 3.15 3.25 41.25 -0.780005 -0.490403 0.779991 1.61053 0.490338 -1.61049 0.0 +1399 3.15 3.25 48.75 -0.160056 -0.188506 0.160035 0.172817 0.188447 -0.172832 0.0 +1400 3.15 3.25 56.25 -0.197253 -0.356173 0.197337 0.156424 0.35612 -0.156432 0.0 +1401 3.15 3.25 63.75 -0.16741 -0.265816 0.167365 0.0571964 0.265815 -0.0571946 0.0 +1402 3.15 3.25 71.25 -0.130237 -0.184874 0.130267 0.00234427 0.184786 -0.0023759 0.0 +1403 3.15 3.25 78.75 -0.0843061 -0.129234 0.0843542 -0.022381 0.129426 0.0223457 0.0 +1404 3.15 3.25 86.25 -0.03979 -0.0657959 0.0398035 -0.0277737 0.0658759 0.0277741 0.0 +1405 3.15 3.25 93.75 -0.00238909 -0.00774928 0.00240125 -0.0282358 0.00785304 0.028235 0.0 +1406 3.15 3.25 101.25 0.0303823 0.0357636 -0.0303854 -0.0222829 -0.0356794 0.0222854 0.0 +1407 3.15 3.25 108.75 0.0506977 0.0585556 -0.0506894 -0.0102554 -0.0584086 0.0102105 0.0 +1408 3.15 3.25 116.25 0.0502104 0.0558613 -0.050186 0.00160465 -0.0559321 -0.00157822 0.0 +1409 3.15 3.25 123.75 0.0345455 0.035523 -0.0344902 0.0104005 -0.0355763 -0.0103987 0.0 +1410 3.15 3.25 131.25 0.0151486 0.0110531 -0.015251 0.0158941 -0.0112994 -0.0157901 0.0 +1411 3.15 3.25 138.75 -0.0050971 -0.013565 0.00511178 0.019016 0.013684 -0.0190174 0.0 +1412 3.15 3.25 146.25 -0.0345021 -0.0459216 0.0345176 0.0233695 0.0459787 -0.0233686 0.0 +1413 3.15 3.25 153.75 -0.0793413 -0.0928252 0.079314 0.0332493 0.092565 -0.033146 0.0 +1414 3.15 3.25 161.25 -0.134603 -0.150218 0.13452 0.0491025 0.150129 -0.0490542 0.0 +1415 3.15 3.25 168.75 -0.18553 -0.204163 0.185623 0.0660649 0.204474 -0.0662343 0.0 +1416 3.15 3.25 176.25 -0.216402 -0.237045 0.216252 0.0770174 0.237253 -0.0771667 0.0 +1417 3.15 3.35 3.75 -275.127 338.879 275.127 11754.8 -338.879 -11754.8 0.0 +1418 3.15 3.35 11.25 -149.928 134.982 149.928 3283.86 -134.982 -3283.86 0.0 +1419 3.15 3.35 18.75 -59.9126 24.6097 59.9126 901.613 -24.6098 -901.613 0.0 +1420 3.15 3.35 26.25 -17.3899 -3.93464 17.3899 190.736 3.93463 -190.736 0.0 +1421 3.15 3.35 33.75 -3.54567 -2.80737 3.54565 25.2257 2.80735 -25.2256 0.0 +1422 3.15 3.35 41.25 -0.5028 -0.297045 0.502764 1.39094 0.297079 -1.39098 0.0 +1423 3.15 3.35 48.75 -0.0786613 -0.21351 0.0785848 0.0781363 0.213592 -0.0781848 0.0 +1424 3.15 3.35 56.25 -0.0749822 -0.340141 0.0749439 0.0885512 0.340151 -0.0884967 0.0 +1425 3.15 3.35 63.75 -0.0903085 -0.233796 0.0902789 0.0251462 0.233735 -0.0251422 0.0 +1426 3.15 3.35 71.25 -0.0742191 -0.168217 0.0742917 -0.0123034 0.168118 0.0122774 0.0 +1427 3.15 3.35 78.75 -0.0442502 -0.131009 0.0441129 -0.0159319 0.131038 0.0159283 0.0 +1428 3.15 3.35 86.25 -0.0140131 -0.074057 0.0140325 -0.0175558 0.0741452 0.0175633 0.0 +1429 3.15 3.35 93.75 0.0107044 -0.016984 -0.0107096 -0.0224514 0.0169392 0.0224516 0.0 +1430 3.15 3.35 101.25 0.0273468 0.0283944 -0.0273571 -0.0182899 -0.0285471 0.0182767 0.0 +1431 3.15 3.35 108.75 0.0341621 0.05763 -0.0342268 -0.00978414 -0.0577058 0.00979257 0.0 +1432 3.15 3.35 116.25 0.0303908 0.0623219 -0.030319 -0.00386081 -0.0623156 0.00386282 0.0 +1433 3.15 3.35 123.75 0.0193498 0.0473473 -0.0192958 0.00117491 -0.0471971 -0.0012989 0.0 +1434 3.15 3.35 131.25 0.00780853 0.0276758 -0.00776157 0.00608841 -0.0275645 -0.00615459 0.0 +1435 3.15 3.35 138.75 -0.00281951 0.00980171 0.0028173 0.00899561 -0.0103754 -0.00875617 0.0 +1436 3.15 3.35 146.25 -0.0177849 -0.0122083 0.0178591 0.0111587 0.0120863 -0.0110729 0.0 +1437 3.15 3.35 153.75 -0.0428755 -0.0468128 0.0427986 0.0164875 0.0467219 -0.0164577 0.0 +1438 3.15 3.35 161.25 -0.0757418 -0.0922436 0.0757394 0.0263114 0.0922185 -0.0263166 0.0 +1439 3.15 3.35 168.75 -0.107642 -0.136426 0.107584 0.0374315 0.136228 -0.0373364 0.0 +1440 3.15 3.35 176.25 -0.127132 -0.16362 0.127062 0.0447389 0.163558 -0.0447096 0.0 +1441 3.15 3.45 3.75 46.6657 326.302 -46.6657 5480.32 -326.302 -5480.32 0.0 +1442 3.15 3.45 11.25 39.3764 154.267 -39.3764 1815.17 -154.267 -1815.17 0.0 +1443 3.15 3.45 18.75 22.0244 42.3138 -22.0244 505.91 -42.3138 -505.91 0.0 +1444 3.15 3.45 26.25 7.29371 4.3406 -7.29372 105.668 -4.3406 -105.668 0.0 +1445 3.15 3.45 33.75 0.914334 -0.603679 -0.914334 13.7287 0.603677 -13.7287 0.0 +1446 3.15 3.45 41.25 -0.158065 -0.0326246 0.158056 0.711344 0.0326778 -0.711315 0.0 +1447 3.15 3.45 48.75 -0.0159738 -0.166204 0.0159671 0.0133403 0.16615 -0.0133219 0.0 +1448 3.15 3.45 56.25 -0.00488119 -0.253233 0.00491148 0.0471634 0.253244 -0.0471562 0.0 +1449 3.15 3.45 63.75 -0.0387289 -0.159738 0.0387929 0.00737726 0.159718 -0.00733701 0.0 +1450 3.15 3.45 71.25 -0.0342167 -0.123108 0.0342095 -0.0134089 0.123119 0.0133794 0.0 +1451 3.15 3.45 78.75 -0.0183889 -0.107233 0.0183971 -0.00702141 0.10719 0.00700092 0.0 +1452 3.15 3.45 86.25 -0.00224304 -0.0672358 0.00223149 -0.00740458 0.06732 0.00740179 0.0 +1453 3.15 3.45 93.75 0.00883338 -0.0235886 -0.00886164 -0.0107045 0.0235433 0.0107089 0.0 +1454 3.15 3.45 101.25 0.0123235 0.015828 -0.012348 -0.00762384 -0.0158064 0.00760398 0.0 +1455 3.15 3.45 108.75 0.0118714 0.0452165 -0.0118843 -0.00509858 -0.0451645 0.00505638 0.0 +1456 3.15 3.45 116.25 0.00859034 0.0531575 -0.00865278 -0.00443542 -0.0532255 0.00444204 0.0 +1457 3.15 3.45 123.75 0.00258788 0.0423716 -0.00256692 -0.00117868 -0.0424366 0.00121603 0.0 +1458 3.15 3.45 131.25 -0.00267606 0.0273421 0.00253797 0.00313079 -0.0273467 -0.00313102 0.0 +1459 3.15 3.45 138.75 -0.00458018 0.0145732 0.00460276 0.00490419 -0.0145389 -0.00492224 0.0 +1460 3.15 3.45 146.25 -0.00839922 -0.00315912 0.00836753 0.00593978 0.00307101 -0.00589991 0.0 +1461 3.15 3.45 153.75 -0.0209444 -0.0338477 0.020904 0.0108714 0.0337667 -0.0108179 0.0 +1462 3.15 3.45 161.25 -0.0433497 -0.0756648 0.043318 0.020838 0.0757092 -0.0208768 0.0 +1463 3.15 3.45 168.75 -0.0683875 -0.116448 0.0683041 0.0321496 0.116416 -0.0321632 0.0 +1464 3.15 3.45 176.25 -0.0847651 -0.141502 0.0847114 0.0395279 0.141475 -0.0394984 0.0 +1465 3.15 3.55 3.75 113.453 150.898 -113.453 1527.06 -150.898 -1527.06 0.0 +1466 3.15 3.55 11.25 75.6979 75.7027 -75.6979 574.861 -75.7027 -574.861 0.0 +1467 3.15 3.55 18.75 35.5664 22.022 -35.5664 161.502 -22.022 -161.502 0.0 +1468 3.15 3.55 26.25 10.941 2.87256 -10.941 32.6315 -2.87256 -32.6315 0.0 +1469 3.15 3.55 33.75 1.72278 0.0375193 -1.7228 3.93133 -0.0374953 -3.93134 0.0 +1470 3.15 3.55 41.25 0.0142898 0.108618 -0.0143047 0.136579 -0.108608 -0.136591 0.0 +1471 3.15 3.55 48.75 0.00816166 -0.0380896 -0.00814953 0.010256 0.0380813 -0.0102749 0.0 +1472 3.15 3.55 56.25 0.0124306 -0.0965177 -0.0124185 0.0389722 0.0965193 -0.0389853 0.0 +1473 3.15 3.55 63.75 -0.00596526 -0.0594462 0.00595775 0.0133454 0.0594234 -0.0133421 0.0 +1474 3.15 3.55 71.25 -0.00358192 -0.0502022 0.00356674 -0.001576 0.0502323 0.00155584 0.0 +1475 3.15 3.55 78.75 0.000427233 -0.0447805 -0.000397985 -0.000360659 0.0448087 0.000358663 0.0 +1476 3.15 3.55 86.25 0.00221954 -0.0289613 -0.00224103 0.000309741 0.0290046 -0.000307859 0.0 +1477 3.15 3.55 93.75 0.00167606 -0.0143391 -0.0016639 0.000808733 0.0143451 -0.000807743 0.0 +1478 3.15 3.55 101.25 0.00112826 0.001235 -0.00111313 0.000644257 -0.00118443 -0.000655222 0.0 +1479 3.15 3.55 108.75 0.00330286 0.0161835 -0.00328457 -0.00210868 -0.0161684 0.00210336 0.0 +1480 3.15 3.55 116.25 0.00487387 0.021415 -0.00489745 -0.00297998 -0.0214282 0.00298062 0.0 +1481 3.15 3.55 123.75 0.00293975 0.016899 -0.00293859 0.000267886 -0.0168868 -0.000264266 0.0 +1482 3.15 3.55 131.25 -0.000108452 0.0105143 0.000105308 0.0034128 -0.0105219 -0.00340601 0.0 +1483 3.15 3.55 138.75 -0.0019759 0.00532812 0.00199003 0.00354695 -0.00537804 -0.00353067 0.0 +1484 3.15 3.55 146.25 -0.00603215 -0.00319989 0.00603288 0.00350166 0.0031536 -0.00347955 0.0 +1485 3.15 3.55 153.75 -0.0177873 -0.0194322 0.017795 0.00752565 0.0194683 -0.00752983 0.0 +1486 3.15 3.55 161.25 -0.0380423 -0.0418389 0.038072 0.0161592 0.041823 -0.016153 0.0 +1487 3.15 3.55 168.75 -0.0604183 -0.0634358 0.0604406 0.025925 0.0634577 -0.0259272 0.0 +1488 3.15 3.55 176.25 -0.0751419 -0.0766462 0.0751429 0.0322594 0.0766293 -0.0322626 0.0 +1489 3.15 3.65 3.75 22.6045 15.6092 -22.6045 111.52 -15.6092 -111.52 0.0 +1490 3.15 3.65 11.25 14.9574 7.74254 -14.9574 45.5783 -7.74254 -45.5783 0.0 +1491 3.15 3.65 18.75 6.90511 1.96171 -6.90511 12.5917 -1.96171 -12.5917 0.0 +1492 3.15 3.65 26.25 2.1033 0.0752923 -2.1033 2.33462 -0.0752924 -2.33462 0.0 +1493 3.15 3.65 33.75 0.345582 -0.0501268 -0.345582 0.224112 0.0501278 -0.224114 0.0 +1494 3.15 3.65 41.25 0.0113715 0.0247154 -0.0113732 -0.00142732 -0.0247142 0.00142719 0.0 +1495 3.15 3.65 48.75 6.87534e-06 0.0140289 -8.51151e-06 0.00563543 -0.0140289 -0.00563605 0.0 +1496 3.15 3.65 56.25 0.00107984 0.0029724 -0.00108132 0.0085864 -0.00297002 -0.00858758 0.0 +1497 3.15 3.65 63.75 0.000469516 0.00270845 -0.000469271 0.00350089 -0.00271011 -0.00350175 0.0 +1498 3.15 3.65 71.25 0.00166924 0.00153728 -0.00167029 0.000471675 -0.00153501 -0.000472585 0.0 +1499 3.15 3.65 78.75 0.00174748 0.00147027 -0.00174735 0.000292892 -0.00147097 -0.000293091 0.0 +1500 3.15 3.65 86.25 0.000889203 0.00101364 -0.000888457 0.000849106 -0.00101254 -0.000849064 0.0 +1501 3.15 3.65 93.75 2.8391e-05 -0.000779719 -2.40476e-05 0.00107302 0.000781464 -0.0010731 0.0 +1502 3.15 3.65 101.25 0.000123662 -0.00119237 -0.000121972 0.000258462 0.00119287 -0.000258603 0.0 +1503 3.15 3.65 108.75 0.000918738 -7.37641e-05 -0.000914812 -0.00070731 7.40479e-05 0.000707953 0.0 +1504 3.15 3.65 116.25 0.00087327 0.000204194 -0.000871841 -0.000333298 -0.000200322 0.000333731 0.0 +1505 3.15 3.65 123.75 -0.000487938 -0.000958429 0.000488243 0.000977954 0.000952902 -0.000975387 0.0 +1506 3.15 3.65 131.25 -0.00192454 -0.00214305 0.00192471 0.00156629 0.00213806 -0.00156455 0.0 +1507 3.15 3.65 138.75 -0.00245031 -0.00237129 0.00244858 0.000874281 0.00237286 -0.000874291 0.0 +1508 3.15 3.65 146.25 -0.00267054 -0.00197417 0.00267194 -7.6905e-05 0.00197292 7.72814e-05 0.0 +1509 3.15 3.65 153.75 -0.00396803 -0.00167631 0.00396857 -7.83088e-05 0.00167684 7.95127e-05 0.0 +1510 3.15 3.65 161.25 -0.00685387 -0.0017756 0.00685877 0.001108 0.0017796 -0.00110938 0.0 +1511 3.15 3.65 168.75 -0.0103819 -0.00210183 0.0103815 0.00276801 0.00210519 -0.00277039 0.0 +1512 3.15 3.65 176.25 -0.0127948 -0.0023518 0.0127908 0.00391691 0.00234768 -0.00391514 0.0 +1513 3.25 3.25 3.75 -516.093 207.353 516.093 17519 -207.353 -17519 0.0 +1514 3.25 3.25 11.25 -297.818 30.2999 297.818 3670.93 -30.2999 -3670.93 0.0 +1515 3.25 3.25 18.75 -131.533 -29.3583 131.533 966.016 29.3582 -966.016 0.0 +1516 3.25 3.25 26.25 -41.2561 -23.5547 41.2561 197.399 23.5547 -197.399 0.0 +1517 3.25 3.25 33.75 -7.77181 -7.42064 7.77175 24.324 7.42059 -24.3239 0.0 +1518 3.25 3.25 41.25 -0.520054 -0.786867 0.520059 1.16473 0.786915 -1.16475 0.0 +1519 3.25 3.25 48.75 -0.135385 -0.107324 0.135384 0.176595 0.107322 -0.176651 0.0 +1520 3.25 3.25 56.25 -0.236403 -0.233969 0.236341 0.100092 0.234021 -0.099998 0.0 +1521 3.25 3.25 63.75 -0.177344 -0.160255 0.177338 0.016127 0.160281 -0.0161542 0.0 +1522 3.25 3.25 71.25 -0.134993 -0.110418 0.134999 -0.0109067 0.110353 0.010913 0.0 +1523 3.25 3.25 78.75 -0.0950825 -0.0779897 0.0951253 -0.021928 0.077927 0.0219105 0.0 +1524 3.25 3.25 86.25 -0.0482799 -0.0371325 0.0482478 -0.0253972 0.0372349 0.0254039 0.0 +1525 3.25 3.25 93.75 -0.00935062 -0.00567433 0.00930825 -0.0233964 0.0056727 0.0233906 0.0 +1526 3.25 3.25 101.25 0.0268556 0.0229776 -0.0268747 -0.016636 -0.0229697 0.0166413 0.0 +1527 3.25 3.25 108.75 0.0559475 0.0486988 -0.0559577 -0.010512 -0.0487913 0.0105343 0.0 +1528 3.25 3.25 116.25 0.0599605 0.0541495 -0.0598537 -0.00538128 -0.0541128 0.00538138 0.0 +1529 3.25 3.25 123.75 0.0386584 0.0352012 -0.038683 0.00205185 -0.0351223 -0.00210039 0.0 +1530 3.25 3.25 131.25 0.0113902 0.00756233 -0.0112221 0.0099077 -0.00759024 -0.00983246 0.0 +1531 3.25 3.25 138.75 -0.0116709 -0.0175027 0.0116404 0.0150778 0.0175656 -0.0151232 0.0 +1532 3.25 3.25 146.25 -0.0379372 -0.0440118 0.0378931 0.0202482 0.0440189 -0.0202764 0.0 +1533 3.25 3.25 153.75 -0.0789016 -0.0826345 0.0789715 0.0309487 0.0826604 -0.0309747 0.0 +1534 3.25 3.25 161.25 -0.13326 -0.134571 0.133258 0.0482225 0.134355 -0.0481305 0.0 +1535 3.25 3.25 168.75 -0.185796 -0.186751 0.185766 0.0666972 0.186837 -0.0667545 0.0 +1536 3.25 3.25 176.25 -0.217924 -0.219808 0.217907 0.078575 0.219826 -0.0785566 0.0 +1537 3.25 3.35 3.75 -136.489 468.84 136.489 13261.2 -468.84 -13261.2 0.0 +1538 3.25 3.35 11.25 -76.3677 186.541 76.3677 3006.19 -186.541 -3006.19 0.0 +1539 3.25 3.35 18.75 -34.4387 38.7843 34.4388 785.234 -38.7843 -785.234 0.0 +1540 3.25 3.35 26.25 -12.2064 -2.42532 12.2063 158.413 2.42535 -158.413 0.0 +1541 3.25 3.35 33.75 -3.01753 -3.19124 3.01752 19.5862 3.19127 -19.5862 0.0 +1542 3.25 3.35 41.25 -0.376538 -0.403329 0.376502 0.965951 0.403384 -0.965979 0.0 +1543 3.25 3.35 48.75 -0.0663706 -0.151905 0.066354 0.0762885 0.151928 -0.0763483 0.0 +1544 3.25 3.35 56.25 -0.115811 -0.241426 0.115854 0.0757353 0.241441 -0.0756865 0.0 +1545 3.25 3.35 63.75 -0.10133 -0.1561 0.101333 0.0257088 0.156123 -0.0256754 0.0 +1546 3.25 3.35 71.25 -0.0830317 -0.123866 0.083011 0.00222966 0.123776 -0.00226914 0.0 +1547 3.25 3.35 78.75 -0.0648663 -0.0963338 0.0649114 -0.00193966 0.0962687 0.00191896 0.0 +1548 3.25 3.35 86.25 -0.0348832 -0.0452658 0.0348888 -0.00953403 0.0452114 0.00953002 0.0 +1549 3.25 3.35 93.75 -0.00930256 -0.00606384 0.00931036 -0.0124204 0.00592252 0.0124271 0.0 +1550 3.25 3.35 101.25 0.0100895 0.0236635 -0.0100704 -0.00601918 -0.0236457 0.00599972 0.0 +1551 3.25 3.35 108.75 0.0265883 0.0477513 -0.0265736 -0.00229502 -0.0475016 0.00223504 0.0 +1552 3.25 3.35 116.25 0.0315534 0.0512958 -0.0315658 -0.00201565 -0.0511774 0.00205073 0.0 +1553 3.25 3.35 123.75 0.0223392 0.0342892 -0.0222605 0.00148067 -0.0341723 -0.00152918 0.0 +1554 3.25 3.35 131.25 0.00941799 0.0153327 -0.00949539 0.00600099 -0.015387 -0.00602979 0.0 +1555 3.25 3.35 138.75 0.00192308 0.00676484 -0.0019709 0.00587968 -0.0067599 -0.00587268 0.0 +1556 3.25 3.35 146.25 -0.00390089 0.00228314 0.00390376 0.00216232 -0.00224221 -0.00219 0.0 +1557 3.25 3.35 153.75 -0.0157319 -0.00974298 0.0157634 0.000201998 0.00958756 -0.00010215 0.0 +1558 3.25 3.35 161.25 -0.0344272 -0.0332355 0.0345224 0.00245974 0.0332678 -0.00241767 0.0 +1559 3.25 3.35 168.75 -0.0539332 -0.0604648 0.0538857 0.00692496 0.0604662 -0.00693555 0.0 +1560 3.25 3.35 176.25 -0.0657833 -0.0784772 0.0659121 0.0101981 0.0784511 -0.0101316 0.0 +1561 3.25 3.45 3.75 160.753 453.103 -160.753 6268.16 -453.103 -6268.16 0.0 +1562 3.25 3.45 11.25 98.9204 211.866 -98.9204 1677.08 -211.866 -1677.08 0.0 +1563 3.25 3.45 18.75 41.6475 62.0615 -41.6475 437.04 -62.0615 -437.04 0.0 +1564 3.25 3.45 26.25 10.2776 8.85177 -10.2776 86.3962 -8.85176 -86.3962 0.0 +1565 3.25 3.45 33.75 0.665198 -0.0281349 -0.665216 10.5941 0.0281541 -10.5942 0.0 +1566 3.25 3.45 41.25 -0.225316 -0.0097665 0.225331 0.540446 0.00977707 -0.540423 0.0 +1567 3.25 3.45 48.75 -0.000555537 -0.138966 0.000568013 0.0245727 0.138941 -0.0245583 0.0 +1568 3.25 3.45 56.25 -0.0247081 -0.191676 0.0246253 0.0387653 0.191736 -0.0387721 0.0 +1569 3.25 3.45 63.75 -0.0406244 -0.104835 0.0405644 0.00218269 0.104904 -0.00218938 0.0 +1570 3.25 3.45 71.25 -0.0316041 -0.0868229 0.0315861 -0.00999292 0.086857 0.00997278 0.0 +1571 3.25 3.45 78.75 -0.0244453 -0.0766617 0.0244139 -0.00348801 0.076724 0.00349178 0.0 +1572 3.25 3.45 86.25 -0.00890648 -0.0447902 0.00892778 -0.00721057 0.0446984 0.00720699 0.0 +1573 3.25 3.45 93.75 0.00249213 -0.015882 -0.00250762 -0.00859341 0.0157787 0.00859132 0.0 +1574 3.25 3.45 101.25 0.00593138 0.0124111 -0.00596771 -0.00363029 -0.0123966 0.00362055 0.0 +1575 3.25 3.45 108.75 0.00849249 0.0372762 -0.00846232 -0.00245363 -0.0373616 0.0024942 0.0 +1576 3.25 3.45 116.25 0.00730472 0.0430354 -0.00734682 -0.00257204 -0.0430353 0.00254668 0.0 +1577 3.25 3.45 123.75 0.000252497 0.0319203 -0.000228003 0.00117018 -0.0317262 -0.00121273 0.0 +1578 3.25 3.45 131.25 -0.00509858 0.0202249 0.00511462 0.00424735 -0.0201591 -0.00429141 0.0 +1579 3.25 3.45 138.75 -0.00189225 0.0157697 0.00192964 0.00188411 -0.0157307 -0.00190094 0.0 +1580 3.25 3.45 146.25 0.00595475 0.0116431 -0.0059073 -0.0030478 -0.0116606 0.00308588 0.0 +1581 3.25 3.45 153.75 0.00984054 -0.000318014 -0.00985575 -0.00518825 0.000191851 0.00524895 0.0 +1582 3.25 3.45 161.25 0.00625952 -0.0201284 -0.00627072 -0.00318494 0.0201728 0.00314475 0.0 +1583 3.25 3.45 168.75 -0.00150526 -0.0406308 0.00144698 0.000485931 0.0405933 -0.00047182 0.0 +1584 3.25 3.45 176.25 -0.00732316 -0.0533522 0.00734119 0.00300328 0.0532394 -0.0029465 0.0 +1585 3.25 3.55 3.75 170.017 215.704 -170.017 1682.14 -215.704 -1682.14 0.0 +1586 3.25 3.55 11.25 104.65 108.392 -104.65 523.152 -108.392 -523.152 0.0 +1587 3.25 3.55 18.75 44.2579 34.3622 -44.2579 134.428 -34.3622 -134.428 0.0 +1588 3.25 3.55 26.25 11.5313 6.21431 -11.5313 25.1215 -6.2143 -25.1215 0.0 +1589 3.25 3.55 33.75 1.18823 0.636226 -1.18825 2.77896 -0.636222 -2.77896 0.0 +1590 3.25 3.55 41.25 -0.090997 0.150717 0.0909756 0.0854078 -0.1507 -0.0854088 0.0 +1591 3.25 3.55 48.75 0.0364606 -0.051279 -0.0364402 0.0168919 0.0512661 -0.0168927 0.0 +1592 3.25 3.55 56.25 0.0111486 -0.090247 -0.0111456 0.0363843 0.090261 -0.0363792 0.0 +1593 3.25 3.55 63.75 -0.0105072 -0.0440459 0.0105073 0.00831444 0.0440284 -0.00831955 0.0 +1594 3.25 3.55 71.25 -0.00433658 -0.0361287 0.00434277 -0.00361399 0.0361351 0.00360689 0.0 +1595 3.25 3.55 78.75 -0.000933427 -0.0350331 0.000939583 -0.00100115 0.0350187 0.00100048 0.0 +1596 3.25 3.55 86.25 0.00219006 -0.0262185 -0.00219325 -0.00134055 0.0262088 0.0013392 0.0 +1597 3.25 3.55 93.75 0.00205156 -0.0171976 -0.00207372 -0.0011449 0.0171792 0.00114581 0.0 +1598 3.25 3.55 101.25 0.000259054 -0.00345069 -0.000235304 -0.00113486 0.00346766 0.00114093 0.0 +1599 3.25 3.55 108.75 0.00134517 0.0104896 -0.0013327 -0.00307345 -0.0104784 0.00307104 0.0 +1600 3.25 3.55 116.25 0.00233262 0.0144818 -0.00234223 -0.00230586 -0.0144733 0.00230359 0.0 +1601 3.25 3.55 123.75 0.00096001 0.00998525 -0.000959656 0.00167455 -0.00992985 -0.00169886 0.0 +1602 3.25 3.55 131.25 0.0010997 0.00500791 -0.00110082 0.00353768 -0.00496742 -0.00356791 0.0 +1603 3.25 3.55 138.75 0.00487751 0.00146684 -0.00487922 0.00142544 -0.00148711 -0.00141137 0.0 +1604 3.25 3.55 146.25 0.00734264 -0.00446313 -0.00734662 -0.000638225 0.00441882 0.000652058 0.0 +1605 3.25 3.55 153.75 0.00197693 -0.014869 -0.00196668 0.0013558 0.0148847 -0.00135051 0.0 +1606 3.25 3.55 161.25 -0.0121606 -0.0275418 0.0121409 0.00720885 0.027516 -0.00721154 0.0 +1607 3.25 3.55 168.75 -0.029033 -0.0382301 0.0290399 0.0137359 0.0382374 -0.01375 0.0 +1608 3.25 3.55 176.25 -0.0403659 -0.0441543 0.0403287 0.0177986 0.0441199 -0.0177946 0.0 +1609 3.25 3.65 3.75 29.8469 23.7536 -29.8469 114.399 -23.7536 -114.399 0.0 +1610 3.25 3.65 11.25 18.5821 12.1922 -18.5821 38.9798 -12.1922 -38.9798 0.0 +1611 3.25 3.65 18.75 7.82427 3.7514 -7.82427 9.32709 -3.7514 -9.32709 0.0 +1612 3.25 3.65 26.25 2.01633 0.610607 -2.01633 1.41075 -0.610606 -1.41076 0.0 +1613 3.25 3.65 33.75 0.207925 0.0661693 -0.207923 0.0650148 -0.0661712 -0.0650166 0.0 +1614 3.25 3.65 41.25 -0.0109411 0.0374143 0.0109448 -0.0172484 -0.0374174 0.0172482 0.0 +1615 3.25 3.65 48.75 0.00854362 0.00771035 -0.00854147 0.00574961 -0.00770984 -0.00574854 0.0 +1616 3.25 3.65 56.25 0.00259756 -0.00264422 -0.00260097 0.00942854 0.00264499 -0.00942948 0.0 +1617 3.25 3.65 63.75 -0.000120554 0.00078573 0.00012058 0.00313857 -0.000784598 -0.00313891 0.0 +1618 3.25 3.65 71.25 0.00248101 0.00185637 -0.00248337 0.000268246 -0.00186001 -0.000268224 0.0 +1619 3.25 3.65 78.75 0.00307847 0.00208771 -0.00307844 0.000606822 -0.00209071 -0.000606483 0.0 +1620 3.25 3.65 86.25 0.00187174 0.00124659 -0.00186937 0.00095551 -0.00124275 -0.000955129 0.0 +1621 3.25 3.65 93.75 6.19913e-05 -0.000371204 -6.04736e-05 0.000563209 0.000365014 -0.000562734 0.0 +1622 3.25 3.65 101.25 -0.000928172 -0.000436879 0.000926995 -0.00063032 0.000434748 0.000630276 0.0 +1623 3.25 3.65 108.75 -0.000830659 0.000473082 0.000832415 -0.00140972 -0.00047285 0.00140969 0.0 +1624 3.25 3.65 116.25 -0.000942827 0.000407146 0.00094397 -0.000633585 -0.000410022 0.000634706 0.0 +1625 3.25 3.65 123.75 -0.00166283 -0.000582597 0.001662 0.000718962 0.000586269 -0.000719648 0.0 +1626 3.25 3.65 131.25 -0.00204479 -0.00128755 0.00204388 0.000938967 0.00128792 -0.000939369 0.0 +1627 3.25 3.65 138.75 -0.00182542 -0.00123409 0.00182692 -0.000123482 0.00123642 0.000123147 0.0 +1628 3.25 3.65 146.25 -0.00225266 -0.000702446 0.00225351 -0.00119521 0.000700296 0.00119733 0.0 +1629 3.25 3.65 153.75 -0.00470753 0.000107114 0.0047067 -0.00120089 -0.000106024 0.00120018 0.0 +1630 3.25 3.65 161.25 -0.00916233 0.00120265 0.0091593 -0.000139049 -0.00120213 0.000137897 0.0 +1631 3.25 3.65 168.75 -0.0140233 0.0024012 0.0140238 0.00124784 -0.00240054 -0.00124848 0.0 +1632 3.25 3.65 176.25 -0.0171689 0.00321938 0.0171732 0.00216427 -0.00322149 -0.00216221 0.0 +1633 3.35 3.35 3.75 21.6477 545.28 -21.6477 11815.8 -545.28 -11815.8 0.0 +1634 3.35 3.35 11.25 0.173729 218.755 -0.173719 2394.74 -218.755 -2394.74 0.0 +1635 3.35 3.35 18.75 -9.53806 48.3705 9.53809 598.087 -48.3705 -598.087 0.0 +1636 3.35 3.35 26.25 -7.66274 -1.12322 7.66276 113.819 1.12321 -113.819 0.0 +1637 3.35 3.35 33.75 -2.74384 -3.33129 2.74384 12.9293 3.33125 -12.9293 0.0 +1638 3.35 3.35 41.25 -0.346706 -0.421196 0.346694 0.581284 0.421155 -0.581292 0.0 +1639 3.35 3.35 48.75 -0.0597258 -0.052617 0.0597015 0.0549515 0.0526707 -0.0549747 0.0 +1640 3.35 3.35 56.25 -0.126882 -0.137188 0.126857 0.0379118 0.137277 -0.0378934 0.0 +1641 3.35 3.35 63.75 -0.109892 -0.0878689 0.109868 0.00253737 0.0878685 -0.00255598 0.0 +1642 3.35 3.35 71.25 -0.0980488 -0.073463 0.0980418 -0.0105894 0.0734524 0.0105771 0.0 +1643 3.35 3.35 78.75 -0.0669262 -0.0528742 0.0669078 -0.0108983 0.0530139 0.0109302 0.0 +1644 3.35 3.35 86.25 -0.0219711 -0.0291652 0.0219318 -0.0154295 0.0291951 0.0154292 0.0 +1645 3.35 3.35 93.75 0.00146699 -0.0207303 -0.00146179 -0.0140867 0.020679 0.0140912 0.0 +1646 3.35 3.35 101.25 0.0168709 0.00290498 -0.0169225 -0.00898105 -0.00281588 0.00896964 0.0 +1647 3.35 3.35 108.75 0.0340663 0.0389815 -0.0340623 -0.0103442 -0.039102 0.0103711 0.0 +1648 3.35 3.35 116.25 0.0352042 0.0499497 -0.0351821 -0.0111656 -0.0499387 0.0111689 0.0 +1649 3.35 3.35 123.75 0.0178821 0.0273981 -0.0178368 -0.0038908 -0.0275323 0.00391568 0.0 +1650 3.35 3.35 131.25 0.00245117 -0.00157526 -0.00237029 0.00543782 0.0017713 -0.00545999 0.0 +1651 3.35 3.35 138.75 -0.000452681 -0.0169013 0.000469283 0.00962862 0.0169401 -0.00965926 0.0 +1652 3.35 3.35 146.25 -0.000710544 -0.0221597 0.000754182 0.0101186 0.0223253 -0.0102137 0.0 +1653 3.35 3.35 153.75 -0.0111111 -0.0323046 0.011189 0.0113797 0.0322223 -0.0112957 0.0 +1654 3.35 3.35 161.25 -0.0318368 -0.0542513 0.0318153 0.0143177 0.0540301 -0.014212 0.0 +1655 3.35 3.35 168.75 -0.0531774 -0.0809936 0.0531282 0.0170487 0.0810135 -0.0171249 0.0 +1656 3.35 3.35 176.25 -0.0660009 -0.0992697 0.0659877 0.01838 0.0992028 -0.0183637 0.0 +1657 3.35 3.45 3.75 264.52 547.577 -264.52 6202.93 -547.577 -6202.93 0.0 +1658 3.35 3.45 11.25 146.664 252.974 -146.664 1327.09 -252.974 -1327.09 0.0 +1659 3.35 3.45 18.75 55.5979 76.7316 -55.5979 320.33 -76.7316 -320.33 0.0 +1660 3.35 3.45 26.25 12.0322 12.2347 -12.0322 58.3259 -12.2346 -58.3259 0.0 +1661 3.35 3.45 33.75 0.596069 0.246217 -0.596031 6.50975 -0.246209 -6.50972 0.0 +1662 3.35 3.45 41.25 -0.174085 -0.0773709 0.174074 0.316004 0.0773448 -0.316022 0.0 +1663 3.35 3.45 48.75 -0.00445633 -0.0860244 0.00448977 0.0121395 0.0860192 -0.0120971 0.0 +1664 3.35 3.45 56.25 -0.0477545 -0.104883 0.0478083 0.0286837 0.104818 -0.0286912 0.0 +1665 3.35 3.45 63.75 -0.0332506 -0.0586084 0.0333016 0.00627557 0.0586119 -0.0062805 0.0 +1666 3.35 3.45 71.25 -0.0281034 -0.0608434 0.0280864 -0.00101144 0.0608456 0.00103223 0.0 +1667 3.35 3.45 78.75 -0.0318181 -0.0457338 0.0317996 0.00287139 0.0457793 -0.00287648 0.0 +1668 3.35 3.45 86.25 -0.0190638 -0.0189326 0.0190873 -0.00282309 0.0188606 0.00282802 0.0 +1669 3.35 3.45 93.75 -0.00845602 -0.00564765 0.00846357 -0.00258802 0.00569123 0.00258276 0.0 +1670 3.35 3.45 101.25 -0.000108637 0.0104483 0.000114753 0.00269483 -0.0103655 -0.00269193 0.0 +1671 3.35 3.45 108.75 0.0096153 0.0272037 -0.00961347 0.00262296 -0.0272254 -0.00260619 0.0 +1672 3.35 3.45 116.25 0.00852246 0.0258295 -0.00856241 0.0019054 -0.0259022 -0.00189501 0.0 +1673 3.35 3.45 123.75 -0.00485077 0.0100252 0.00491377 0.00479164 -0.010035 -0.00474465 0.0 +1674 3.35 3.45 131.25 -0.0151032 -0.00124015 0.0150869 0.00590864 0.00128885 -0.00595605 0.0 +1675 3.35 3.45 138.75 -0.0116773 0.000794051 0.0116531 0.00155451 -0.000693976 -0.00161011 0.0 +1676 3.35 3.45 146.25 0.000951708 0.00984726 -0.000976147 -0.00547841 -0.00985363 0.00546737 0.0 +1677 3.35 3.45 153.75 0.0141348 0.0178974 -0.0141348 -0.0120161 -0.0179225 0.0120171 0.0 +1678 3.35 3.45 161.25 0.024418 0.0223568 -0.0244107 -0.0180532 -0.022375 0.0180171 0.0 +1679 3.35 3.45 168.75 0.0321657 0.0245203 -0.0321044 -0.0239933 -0.0245871 0.0240198 0.0 +1680 3.35 3.45 176.25 0.0366433 0.0254514 -0.0366767 -0.0281044 -0.0255168 0.0281336 0.0 +1681 3.35 3.55 3.75 212.112 270.322 -212.112 1633.44 -270.322 -1633.44 0.0 +1682 3.35 3.55 11.25 122.019 134.508 -122.019 394.591 -134.508 -394.591 0.0 +1683 3.35 3.55 18.75 47.7974 44.519 -47.7974 89.0516 -44.519 -89.0516 0.0 +1684 3.35 3.55 26.25 11.0171 8.96418 -11.0171 14.3465 -8.96418 -14.3466 0.0 +1685 3.35 3.55 33.75 0.785538 1.00667 -0.785533 1.3707 -1.00666 -1.37071 0.0 +1686 3.35 3.55 41.25 -0.100275 0.111814 0.100273 0.063653 -0.111807 -0.0636804 0.0 +1687 3.35 3.55 48.75 0.0358723 -0.0504078 -0.0358729 0.0207167 0.0504272 -0.0207188 0.0 +1688 3.35 3.55 56.25 -0.0107991 -0.0545945 0.0108077 0.0260469 0.0545759 -0.0260665 0.0 +1689 3.35 3.55 63.75 -0.0137965 -0.0162173 0.01382 0.00310984 0.0162029 -0.00312469 0.0 +1690 3.35 3.55 71.25 -0.00443791 -0.0176794 0.00444316 -0.0030039 0.0176744 0.00300773 0.0 +1691 3.35 3.55 78.75 -0.00661178 -0.0194646 0.00662503 -0.000183672 0.0194799 0.000190292 0.0 +1692 3.35 3.55 86.25 -0.0044624 -0.0145146 0.00445811 -0.00308715 0.0145483 0.00308949 0.0 +1693 3.35 3.55 93.75 -0.00201713 -0.0103082 0.00203467 -0.0034837 0.0103487 0.00348302 0.0 +1694 3.35 3.55 101.25 0.000612684 -0.00214047 -0.000633647 -0.00170294 0.00208873 0.00170816 0.0 +1695 3.35 3.55 108.75 0.00492679 0.00544074 -0.00492725 -0.000964504 -0.00547196 0.000980009 0.0 +1696 3.35 3.55 116.25 0.00552459 0.00494329 -0.00551079 0.00128236 -0.00490754 -0.00128794 0.0 +1697 3.35 3.55 123.75 0.00248381 -0.000309276 -0.00248587 0.00443651 0.000330766 -0.00443577 0.0 +1698 3.35 3.55 131.25 0.00307595 -0.00427668 -0.00308807 0.00457978 0.00431048 -0.00460838 0.0 +1699 3.35 3.55 138.75 0.0100829 -0.00649667 -0.0100649 0.00162916 0.00646752 -0.00160639 0.0 +1700 3.35 3.55 146.25 0.0183636 -0.0087324 -0.0183591 -0.00101933 0.00878923 0.000998688 0.0 +1701 3.35 3.55 153.75 0.0223417 -0.00978813 -0.0223341 -0.00163428 0.00977234 0.00164318 0.0 +1702 3.35 3.55 161.25 0.0213234 -0.00730229 -0.0213443 -0.0014192 0.00724781 0.00144804 0.0 +1703 3.35 3.55 168.75 0.0183265 -0.00180711 -0.0183314 -0.00178155 0.00182466 0.00177075 0.0 +1704 3.35 3.55 176.25 0.0161793 0.00277081 -0.0161889 -0.00245834 -0.00278613 0.00245868 0.0 +1705 3.35 3.65 3.75 34.2993 31.2111 -34.2993 99.1827 -31.2111 -99.1827 0.0 +1706 3.35 3.65 11.25 20.1073 16.1249 -20.1073 25.0862 -16.1249 -25.0862 0.0 +1707 3.35 3.65 18.75 7.81038 5.38483 -7.81038 4.29487 -5.38483 -4.29487 0.0 +1708 3.35 3.65 26.25 1.72232 1.10266 -1.72232 0.220387 -1.10265 -0.220388 0.0 +1709 3.35 3.65 33.75 0.0886792 0.151586 -0.0886799 -0.0820027 -0.151586 0.0820019 0.0 +1710 3.35 3.65 41.25 -0.0173171 0.0309048 0.0173154 -0.015518 -0.0309058 0.0155196 0.0 +1711 3.35 3.65 48.75 0.0101661 -0.00286499 -0.0101673 0.00763683 0.00286567 -0.00763753 0.0 +1712 3.35 3.65 56.25 -0.002689 -0.00624694 0.00268935 0.0083081 0.00624704 -0.00830852 0.0 +1713 3.35 3.65 63.75 -0.00312949 0.000414859 0.00313187 0.00248767 -0.000415121 -0.00248719 0.0 +1714 3.35 3.65 71.25 0.00176759 0.00183364 -0.00176593 0.000912355 -0.00183059 -0.000912314 0.0 +1715 3.35 3.65 78.75 0.00272836 0.00157348 -0.00272759 0.00117466 -0.00157332 -0.00117415 0.0 +1716 3.35 3.65 86.25 0.00159309 0.000928734 -0.00159386 0.000236076 -0.000929755 -0.000236263 0.0 +1717 3.35 3.65 93.75 -8.27674e-05 0.000144333 8.23358e-05 -0.00112934 -0.000145183 0.00112914 0.0 +1718 3.35 3.65 101.25 -0.000947847 0.000224482 0.00094892 -0.00225916 -0.000225888 0.00225973 0.0 +1719 3.35 3.65 108.75 -0.000863792 0.000432852 0.000864512 -0.00237019 -0.000431765 0.0023699 0.0 +1720 3.35 3.65 116.25 -0.000961541 -5.64864e-05 0.000960868 -0.0011264 6.07289e-05 0.00112608 0.0 +1721 3.35 3.65 123.75 -0.00127243 -0.000805706 0.0012707 0.000252729 0.000806025 -0.000253886 0.0 +1722 3.35 3.65 131.25 -0.000913381 -0.00130653 0.000910966 0.000474326 0.00130583 -0.000474541 0.0 +1723 3.35 3.65 138.75 -5.53154e-05 -0.00154588 5.78325e-05 -0.000286174 0.00155054 0.000285032 0.0 +1724 3.35 3.65 146.25 -6.51777e-05 -0.00124019 6.5744e-05 -0.000995048 0.00124163 0.000994467 0.0 +1725 3.35 3.65 153.75 -0.0019038 0.00032226 0.00190333 -0.00107275 -0.000320901 0.00107123 0.0 +1726 3.35 3.65 161.25 -0.00517932 0.00335224 0.00517862 -0.000703318 -0.00335729 0.000705883 0.0 +1727 3.35 3.65 168.75 -0.00853589 0.00691614 0.00853695 -0.000307448 -0.00691271 0.000304936 0.0 +1728 3.35 3.65 176.25 -0.0106065 0.00934073 0.0106054 -0.000100664 -0.0093421 0.000101267 0.0 +1729 3.45 3.45 3.75 249.963 447.743 -249.963 3664.97 -447.743 -3664.97 0.0 +1730 3.45 3.45 11.25 130.312 207.993 -130.312 676.249 -207.993 -676.249 0.0 +1731 3.45 3.45 18.75 45.7667 65.0303 -45.7667 147.519 -65.0303 -147.519 0.0 +1732 3.45 3.45 26.25 8.62768 11.3441 -8.62769 23.4633 -11.3441 -23.4633 0.0 +1733 3.45 3.45 33.75 0.110016 0.590793 -0.109988 2.30758 -0.590787 -2.3076 0.0 +1734 3.45 3.45 41.25 -0.153757 -0.0039627 0.153717 0.133259 0.00394772 -0.133226 0.0 +1735 3.45 3.45 48.75 -0.0153495 -0.0393026 0.0153515 0.00700061 0.0393356 -0.00698054 0.0 +1736 3.45 3.45 56.25 -0.0482726 -0.073912 0.0483149 0.0251197 0.0739223 -0.0251188 0.0 +1737 3.45 3.45 63.75 -0.0289355 -0.0533479 0.0289021 0.00597862 0.053373 -0.00597884 0.0 +1738 3.45 3.45 71.25 -0.0187811 -0.0391984 0.018746 0.000512192 0.039198 -0.000501842 0.0 +1739 3.45 3.45 78.75 -0.00856621 -0.0176478 0.00859924 0.00690296 0.0177056 -0.00690308 0.0 +1740 3.45 3.45 86.25 0.00371125 -0.0135792 -0.00372377 0.00136037 0.0136089 -0.0013601 0.0 +1741 3.45 3.45 93.75 0.00477561 -0.0238325 -0.00478562 -0.00283706 0.0238591 0.00283968 0.0 +1742 3.45 3.45 101.25 0.00818656 -0.0174538 -0.00812902 -0.00263731 0.017444 0.00264151 0.0 +1743 3.45 3.45 108.75 0.0169419 0.00155597 -0.0169639 -0.00543721 -0.00155808 0.00543126 0.0 +1744 3.45 3.45 116.25 0.0195788 0.0116859 -0.0195369 -0.00999959 -0.0117365 0.0100136 0.0 +1745 3.45 3.45 123.75 0.0183927 0.0116238 -0.0183971 -0.013227 -0.011666 0.0132448 0.0 +1746 3.45 3.45 131.25 0.0233808 0.0121941 -0.0234038 -0.0149326 -0.0122148 0.0149266 0.0 +1747 3.45 3.45 138.75 0.0316355 0.0161105 -0.0316222 -0.0142598 -0.0161126 0.0142499 0.0 +1748 3.45 3.45 146.25 0.0319972 0.0182352 -0.0319926 -0.0107349 -0.018201 0.0107262 0.0 +1749 3.45 3.45 153.75 0.0212885 0.0151617 -0.0213003 -0.0072284 -0.0151286 0.00721379 0.0 +1750 3.45 3.45 161.25 0.00710262 0.00875975 -0.00709702 -0.00763624 -0.00879653 0.00766868 0.0 +1751 3.45 3.45 168.75 -0.0026401 0.00265877 0.00265377 -0.0121265 -0.00270055 0.0121613 0.0 +1752 3.45 3.45 176.25 -0.00643116 -0.000726218 0.00644015 -0.0165154 0.000842039 0.0164549 0.0 +1753 3.45 3.55 3.75 176.165 231.846 -176.165 1002.13 -231.846 -1002.13 0.0 +1754 3.45 3.55 11.25 95.7124 114.358 -95.7124 175.442 -114.358 -175.442 0.0 +1755 3.45 3.55 18.75 35.3486 38.8706 -35.3486 30.2113 -38.8706 -30.2113 0.0 +1756 3.45 3.55 26.25 7.45817 8.24142 -7.45818 2.93187 -8.24142 -2.93187 0.0 +1757 3.45 3.55 33.75 0.442038 0.937077 -0.442023 0.16053 -0.937083 -0.160524 0.0 +1758 3.45 3.55 41.25 -0.036135 0.0544695 0.0361478 0.0475514 -0.0544678 -0.0475693 0.0 +1759 3.45 3.55 48.75 0.0114763 -0.0262494 -0.0114589 0.0137087 0.0262505 -0.0137065 0.0 +1760 3.45 3.55 56.25 -0.0247279 -0.0151853 0.0247269 0.0138833 0.0151975 -0.0138936 0.0 +1761 3.45 3.55 63.75 -0.00534614 0.000359977 0.00535626 -0.000883675 -0.000355567 0.000884282 0.0 +1762 3.45 3.55 71.25 0.0021508 -0.00431124 -0.00217205 -0.00167595 0.00430117 0.00167024 0.0 +1763 3.45 3.55 78.75 -0.00618242 -0.0011063 0.00617677 0.00219776 0.00111944 -0.00219769 0.0 +1764 3.45 3.55 86.25 -0.00864154 0.00382556 0.00863024 -0.000880014 -0.00382877 0.000881011 0.0 +1765 3.45 3.55 93.75 -0.00688417 0.00308196 0.00688064 -0.000591138 -0.00307945 0.000591269 0.0 +1766 3.45 3.55 101.25 -0.00277733 0.00250811 0.00278446 0.00339576 -0.00248041 -0.00339897 0.0 +1767 3.45 3.55 108.75 9.6645e-05 0.00292517 -9.27955e-05 0.00533124 -0.00297869 -0.00532125 0.0 +1768 3.45 3.55 116.25 -0.00279109 0.00312423 0.0027777 0.004826 -0.00313043 -0.00482587 0.0 +1769 3.45 3.55 123.75 -0.007852 0.00420337 0.00785189 0.00337755 -0.00423422 -0.00336561 0.0 +1770 3.45 3.55 131.25 -0.00899665 0.00525366 0.00898163 0.00211415 -0.00526556 -0.00211688 0.0 +1771 3.45 3.55 138.75 -0.00658818 0.00353401 0.00658935 0.00247574 -0.00351467 -0.00247806 0.0 +1772 3.45 3.55 146.25 -0.00472251 -0.000274464 0.0047137 0.00454554 0.000265355 -0.00453667 0.0 +1773 3.45 3.55 153.75 -0.00408631 -0.00145214 0.00408205 0.00601461 0.00145164 -0.0060113 0.0 +1774 3.45 3.55 161.25 -0.00213812 0.00336809 0.00214451 0.0045329 -0.00336917 -0.00453833 0.0 +1775 3.45 3.55 168.75 0.002039 0.0122448 -0.00204369 0.000537346 -0.0122471 -0.000536574 0.0 +1776 3.45 3.55 176.25 0.00576826 0.0191805 -0.00579318 -0.00289312 -0.0192316 0.00291892 0.0 +1777 3.45 3.65 3.75 27.0106 27.9613 -27.0106 49.4083 -27.9613 -49.4083 0.0 +1778 3.45 3.65 11.25 14.9394 14.3629 -14.9394 5.91574 -14.3629 -5.91574 0.0 +1779 3.45 3.65 18.75 5.42704 4.99328 -5.42704 -0.785154 -4.99328 0.785155 0.0 +1780 3.45 3.65 26.25 1.05899 1.10476 -1.05899 -0.658621 -1.10476 0.658622 0.0 +1781 3.45 3.65 33.75 0.0281818 0.145917 -0.0281832 -0.129014 -0.145916 0.129014 0.0 +1782 3.45 3.65 41.25 -0.00445013 0.00847625 0.00444947 -0.00108348 -0.0084749 0.00108322 0.0 +1783 3.45 3.65 48.75 0.00425589 -0.0101956 -0.00425551 0.00738506 0.0101965 -0.00738428 0.0 +1784 3.45 3.65 56.25 -0.00818272 -0.00590468 0.00818308 0.00485965 0.00590354 -0.00486006 0.0 +1785 3.45 3.65 63.75 -0.00416452 -0.000816284 0.00416288 0.00103036 0.000813653 -0.00103209 0.0 +1786 3.45 3.65 71.25 0.00103127 -0.00146141 -0.00103277 0.000818187 0.00146199 -0.000819189 0.0 +1787 3.45 3.65 78.75 0.0016058 -0.00187691 -0.00160474 0.000733485 0.00187607 -0.000733211 0.0 +1788 3.45 3.65 86.25 0.00109362 -0.000919641 -0.00109306 -0.000877938 0.000920276 0.000877779 0.0 +1789 3.45 3.65 93.75 0.000615382 -0.000162543 -0.000614614 -0.00196718 0.000162038 0.00196727 0.0 +1790 3.45 3.65 101.25 0.000257077 -9.90887e-05 -0.000257803 -0.00198713 9.8806e-05 0.00198727 0.0 +1791 3.45 3.65 108.75 -0.000415666 -0.000551723 0.000416382 -0.00133258 0.000550085 0.00133277 0.0 +1792 3.45 3.65 116.25 -0.00171058 -0.00100344 0.00171033 -0.000283121 0.00100575 0.000281567 0.0 +1793 3.45 3.65 123.75 -0.00282345 -0.00136999 0.00282231 0.000681739 0.00136679 -0.000680174 0.0 +1794 3.45 3.65 131.25 -0.00293906 -0.00227991 0.00293814 0.00125143 0.00227664 -0.00125029 0.0 +1795 3.45 3.65 138.75 -0.00235433 -0.00392254 0.0023561 0.0016008 0.00392512 -0.00160107 0.0 +1796 3.45 3.65 146.25 -0.00181787 -0.00523799 0.00181858 0.00193355 0.00523773 -0.00193291 0.0 +1797 3.45 3.65 153.75 -0.00147655 -0.00473654 0.00147561 0.00211445 0.00473647 -0.00211477 0.0 +1798 3.45 3.65 161.25 -0.000967812 -0.00201348 0.000967111 0.00191586 0.00201087 -0.00191381 0.0 +1799 3.45 3.65 168.75 -0.000185572 0.00169462 0.000184459 0.00140918 -0.00169418 -0.00140983 0.0 +1800 3.45 3.65 176.25 0.000452234 0.00431542 -0.000452919 0.000978651 -0.00431348 -0.000979895 0.0 +1801 3.55 3.55 3.75 81.0059 113.34 -81.0059 260.352 -113.34 -260.352 0.0 +1802 3.55 3.55 11.25 42.1524 56.4121 -42.1524 26.3617 -56.4121 -26.3617 0.0 +1803 3.55 3.55 18.75 14.7132 19.7973 -14.7132 -0.755035 -19.7973 0.755033 0.0 +1804 3.55 3.55 26.25 2.79612 4.5306 -2.79613 -1.38915 -4.53059 1.38915 0.0 +1805 3.55 3.55 33.75 0.10053 0.64794 -0.100533 -0.160016 -0.647941 0.160018 0.0 +1806 3.55 3.55 41.25 -0.0178303 0.07505 0.0178293 0.0195223 -0.0750523 -0.0195244 0.0 +1807 3.55 3.55 48.75 -0.00517875 -0.00351167 0.00518041 0.00760166 0.00350383 -0.00760536 0.0 +1808 3.55 3.55 56.25 -0.0146237 -0.0107977 0.0146179 0.0109189 0.0107984 -0.0109269 0.0 +1809 3.55 3.55 63.75 -3.87507e-05 -0.00362228 4.15324e-05 -0.000860953 0.0036153 0.000862609 0.0 +1810 3.55 3.55 71.25 0.00025554 0.00310581 -0.000258051 -0.00193062 -0.00311301 0.00192984 0.0 +1811 3.55 3.55 78.75 -0.00939829 0.0115235 0.0094016 0.000961058 -0.0115276 -0.000962838 0.0 +1812 3.55 3.55 86.25 -0.0165596 0.0133942 0.0165552 -0.000618444 -0.0133937 0.000618414 0.0 +1813 3.55 3.55 93.75 -0.0192198 0.0081303 0.0192237 0.000800086 -0.00813014 -0.000800389 0.0 +1814 3.55 3.55 101.25 -0.0173135 0.00397392 0.017316 0.00498683 -0.0039722 -0.00498686 0.0 +1815 3.55 3.55 108.75 -0.0127763 0.00613703 0.0127729 0.00547732 -0.00614031 -0.00547708 0.0 +1816 3.55 3.55 116.25 -0.00660985 0.0146966 0.00660871 0.000809944 -0.0146938 -0.000810497 0.0 +1817 3.55 3.55 123.75 0.00134833 0.025362 -0.00135008 -0.00514917 -0.0253577 0.0051477 0.0 +1818 3.55 3.55 131.25 0.00729171 0.0312649 -0.00729682 -0.00779015 -0.0312805 0.00779548 0.0 +1819 3.55 3.55 138.75 0.00442273 0.0279187 -0.00442424 -0.00517592 -0.0279147 0.00517078 0.0 +1820 3.55 3.55 146.25 -0.0095565 0.0168767 0.00955964 0.000965394 -0.0168727 -0.000968108 0.0 +1821 3.55 3.55 153.75 -0.0293138 0.00381127 0.0293123 0.00695552 -0.00382228 -0.00695117 0.0 +1822 3.55 3.55 161.25 -0.0467198 -0.00619086 0.0467172 0.0101031 0.00618452 -0.0101001 0.0 +1823 3.55 3.55 168.75 -0.0572524 -0.0115126 0.0572543 0.0103575 0.0115196 -0.0103592 0.0 +1824 3.55 3.55 176.25 -0.0614583 -0.0133864 0.0614549 0.00960442 0.0133863 -0.00960501 0.0 +1825 3.55 3.65 3.75 12.0786 14.33 -12.0786 4.38613 -14.33 -4.38613 0.0 +1826 3.55 3.65 11.25 6.33912 7.33576 -6.33912 -3.18423 -7.33576 3.18423 0.0 +1827 3.55 3.65 18.75 2.17784 2.6298 -2.17784 -1.96003 -2.6298 1.96003 0.0 +1828 3.55 3.65 26.25 0.39006 0.617253 -0.390059 -0.575786 -0.617253 0.575786 0.0 +1829 3.55 3.65 33.75 0.012681 0.0862211 -0.0126807 -0.0681723 -0.0862212 0.0681722 0.0 +1830 3.55 3.65 41.25 0.00502234 0.00223156 -0.00502212 0.00459513 -0.00223169 -0.00459442 0.0 +1831 3.55 3.65 48.75 0.00119944 -0.00628422 -0.00119894 0.00406756 0.00628446 -0.004068 0.0 +1832 3.55 3.65 56.25 -0.00386742 -0.003943 0.0038666 0.00178896 0.00394351 -0.00178918 0.0 +1833 3.55 3.65 63.75 -8.12468e-05 -0.00348925 8.0267e-05 -0.000674629 0.00348964 0.000674362 0.0 +1834 3.55 3.65 71.25 0.00192557 -0.00505585 -0.00192533 -0.00075298 0.00505521 0.00075297 0.0 +1835 3.55 3.65 78.75 0.00130323 -0.00454114 -0.0013032 -0.000636843 0.00454084 0.000636893 0.0 +1836 3.55 3.65 86.25 0.000803867 -0.00245655 -0.00080399 -0.00102105 0.0024577 0.00102106 0.0 +1837 3.55 3.65 93.75 0.0005973 -0.00111275 -0.000596389 -0.00057336 0.00111433 0.000573242 0.0 +1838 3.55 3.65 101.25 8.21929e-06 -0.00103481 -8.12152e-06 0.000450279 0.00103466 -0.00045023 0.0 +1839 3.55 3.65 108.75 -0.00119309 -0.00126494 0.00119399 0.0010993 0.00126523 -0.00109935 0.0 +1840 3.55 3.65 116.25 -0.00250233 -0.00111306 0.0025023 0.00122707 0.00111394 -0.00122737 0.0 +1841 3.55 3.65 123.75 -0.00325961 -0.00112678 0.00325939 0.00125572 0.00112681 -0.00125599 0.0 +1842 3.55 3.65 131.25 -0.0035151 -0.00233904 0.00351542 0.00158179 0.00233879 -0.00158147 0.0 +1843 3.55 3.65 138.75 -0.00380524 -0.00487295 0.00380513 0.00228977 0.0048732 -0.00229011 0.0 +1844 3.55 3.65 146.25 -0.00421555 -0.00763611 0.00421483 0.00312216 0.00763468 -0.00312155 0.0 +1845 3.55 3.65 153.75 -0.0041875 -0.00929866 0.0041879 0.00369562 0.00929919 -0.00369561 0.0 +1846 3.55 3.65 161.25 -0.00326306 -0.00936525 0.00326349 0.00381045 0.00936578 -0.00381069 0.0 +1847 3.55 3.65 168.75 -0.00175148 -0.00841033 0.00175132 0.00358917 0.00841037 -0.00358917 0.0 +1848 3.55 3.65 176.25 -0.000592392 -0.007527 0.000592354 0.00335056 0.00752733 -0.00335069 0.0 +1849 3.65 3.65 3.75 1.34179 1.8764 -1.34179 -2.21207 -1.8764 2.21207 0.0 +1850 3.65 3.65 11.25 0.674722 0.975627 -0.674722 -1.01114 -0.975627 1.01114 0.0 +1851 3.65 3.65 18.75 0.218094 0.365855 -0.218094 -0.384938 -0.365855 0.384938 0.0 +1852 3.65 3.65 26.25 0.034533 0.0959486 -0.034533 -0.0883541 -0.0959486 0.0883541 0.0 +1853 3.65 3.65 33.75 0.000906004 0.0183831 -0.000905993 -0.00778172 -0.0183832 0.00778172 0.0 +1854 3.65 3.65 41.25 0.00132048 0.00271731 -0.00132051 0.00071098 -0.00271729 -0.000710997 0.0 +1855 3.65 3.65 48.75 0.000821636 -0.000306112 -0.00082155 0.000743727 0.000306079 -0.000743719 0.0 +1856 3.65 3.65 56.25 0.00055949 -0.000894959 -0.000559485 0.000325653 0.000894939 -0.000325638 0.0 +1857 3.65 3.65 63.75 0.000919031 -0.00134167 -0.000918928 -0.000425567 0.0013417 0.000425618 0.0 +1858 3.65 3.65 71.25 0.00068388 -0.00161126 -0.000683975 -0.000595268 0.00161117 0.000595242 0.0 +1859 3.65 3.65 78.75 0.000214632 -0.00126472 -0.000214751 -0.000489084 0.00126474 0.000489099 0.0 +1860 3.65 3.65 86.25 8.67817e-06 -0.000701107 -8.75836e-06 -0.000274181 0.00070111 0.000274184 0.0 +1861 3.65 3.65 93.75 1.71384e-06 -0.000443281 -1.76788e-06 0.000154524 0.000443329 -0.000154528 0.0 +1862 3.65 3.65 101.25 1.95029e-05 -0.000477718 -1.95794e-05 0.000567489 0.000477841 -0.000567493 0.0 +1863 3.65 3.65 108.75 7.48783e-05 -0.00049436 -7.48748e-05 0.000683729 0.000494453 -0.000683746 0.0 +1864 3.65 3.65 116.25 0.000265232 -0.000391767 -0.000265328 0.00052426 0.000391822 -0.000524261 0.0 +1865 3.65 3.65 123.75 0.000509939 -0.000400182 -0.000509922 0.000310119 0.000400276 -0.000310147 0.0 +1866 3.65 3.65 131.25 0.000525607 -0.000787876 -0.000525615 0.000228989 0.000787858 -0.00022897 0.0 +1867 3.65 3.65 138.75 0.000108536 -0.00156718 -0.000108471 0.000330074 0.00156723 -0.000330079 0.0 +1868 3.65 3.65 146.25 -0.000640149 -0.00249673 0.000640125 0.000548861 0.00249673 -0.000548895 0.0 +1869 3.65 3.65 153.75 -0.0014021 -0.00329158 0.00140212 0.000784814 0.00329161 -0.000784826 0.0 +1870 3.65 3.65 161.25 -0.00190979 -0.00380299 0.00190977 0.000966445 0.00380303 -0.000966483 0.0 +1871 3.65 3.65 168.75 -0.00211603 -0.00404799 0.00211605 0.00107292 0.004048 -0.00107292 0.0 +1872 3.65 3.65 176.25 -0.00215132 -0.00412886 0.00215137 0.00111754 0.00412895 -0.00111757 0.0 diff --git a/examples/PACKAGES/pair_3b_table/1-1-2.table b/examples/PACKAGES/pair_3b_table/1-1-2.table new file mode 100644 index 0000000000..528627f03a --- /dev/null +++ b/examples/PACKAGES/pair_3b_table/1-1-2.table @@ -0,0 +1,3459 @@ +ENTRY1 +N 12 rmin 2.55 rmax 3.65 + +1 2.55 2.55 3.75 -867.212 -611.273 867.212 21386.8 611.273 -21386.8 0.0 +2 2.55 2.55 11.25 -621.539 -411.189 621.539 5035.95 411.189 -5035.95 0.0 +3 2.55 2.55 18.75 -394.167 -243.287 394.167 1722.21 243.287 -1722.21 0.0 +4 2.55 2.55 26.25 -218.789 -127.402 218.789 560.206 127.402 -560.206 0.0 +5 2.55 2.55 33.75 -104.252 -59.5774 104.252 156.639 59.5774 -156.639 0.0 +6 2.55 2.55 41.25 -41.0722 -24.6716 41.072 36.4446 24.6716 -36.4446 0.0 +7 2.55 2.55 48.75 -12.357 -8.38061 12.3571 7.1117 8.38062 -7.1117 0.0 +8 2.55 2.55 56.25 -2.29912 -1.68047 2.29907 0.91657 1.68048 -0.916568 0.0 +9 2.55 2.55 63.75 -0.0509977 0.327321 0.0509129 -0.304729 -0.327319 0.30474 0.0 +10 2.55 2.55 71.25 0.0345509 0.431792 -0.0345867 -0.382614 -0.431782 0.382616 0.0 +11 2.55 2.55 78.75 -0.00019898 0.179593 0.000319523 -0.292658 -0.179608 0.292661 0.0 +12 2.55 2.55 86.25 0.154169 0.138217 -0.154088 -0.302917 -0.138224 0.302914 0.0 +13 2.55 2.55 93.75 0.327691 0.263922 -0.327675 -0.340147 -0.263894 0.340148 0.0 +14 2.55 2.55 101.25 0.382895 0.350591 -0.382883 -0.297308 -0.350546 0.297312 0.0 +15 2.55 2.55 108.75 0.300955 0.297417 -0.300746 -0.173862 -0.297437 0.173872 0.0 +16 2.55 2.55 116.25 0.138507 0.141879 -0.138328 -0.0349372 -0.1418 0.0349415 0.0 +17 2.55 2.55 123.75 -0.0287949 -0.0286834 0.0286744 0.065848 0.0287665 -0.0658601 0.0 +18 2.55 2.55 131.25 -0.160323 -0.164235 0.160302 0.120341 0.164191 -0.120297 0.0 +19 2.55 2.55 138.75 -0.274013 -0.280673 0.274077 0.156939 0.280642 -0.156913 0.0 +20 2.55 2.55 146.25 -0.42361 -0.430992 0.423711 0.212433 0.430824 -0.212358 0.0 +21 2.55 2.55 153.75 -0.648177 -0.651719 0.648516 0.305821 0.651726 -0.305791 0.0 +22 2.55 2.55 161.25 -0.93181 -0.926724 0.931895 0.426805 0.926702 -0.426778 0.0 +23 2.55 2.55 168.75 -1.20276 -1.18735 1.20273 0.541966 1.18745 -0.542019 0.0 +24 2.55 2.55 176.25 -1.36933 -1.34705 1.3691 0.612284 1.34703 -0.612297 0.0 +25 2.55 2.65 3.75 -784.444 -675.519 784.444 19696.9 675.519 -19696.9 0.0 +26 2.55 2.65 11.25 -542.941 -440.852 542.941 5300.59 440.852 -5300.59 0.0 +27 2.55 2.65 18.75 -325.839 -241.234 325.839 1817.37 241.234 -1817.37 0.0 +28 2.55 2.65 26.25 -169.421 -111.015 169.421 580.214 111.015 -580.214 0.0 +29 2.55 2.65 33.75 -74.994 -43.3669 74.994 155.496 43.3669 -155.496 0.0 +30 2.55 2.65 41.25 -27.0736 -14.8824 27.0736 33.1152 14.8824 -33.1152 0.0 +31 2.55 2.65 48.75 -7.12613 -4.62454 7.12621 5.36809 4.62453 -5.36811 0.0 +32 2.55 2.65 56.25 -0.874199 -1.13723 0.874234 0.34195 1.13723 -0.341919 0.0 +33 2.55 2.65 63.75 0.204812 -0.0406907 -0.204883 -0.442652 0.0407084 0.442642 0.0 +34 2.55 2.65 71.25 0.0904568 0.154881 -0.0905494 -0.435451 -0.154894 0.435459 0.0 +35 2.55 2.65 78.75 0.0458835 0.126591 -0.0460614 -0.333955 -0.126573 0.33396 0.0 +36 2.55 2.65 86.25 0.168148 0.163197 -0.168343 -0.309845 -0.163197 0.309848 0.0 +37 2.55 2.65 93.75 0.296449 0.261093 -0.296361 -0.307947 -0.261084 0.307954 0.0 +38 2.55 2.65 101.25 0.329963 0.311331 -0.329831 -0.254571 -0.311318 0.254565 0.0 +39 2.55 2.65 108.75 0.253841 0.255391 -0.253789 -0.146686 -0.255437 0.146721 0.0 +40 2.55 2.65 116.25 0.107857 0.119105 -0.107492 -0.0254819 -0.119136 0.0254837 0.0 +41 2.55 2.65 123.75 -0.0492191 -0.0344023 0.0490594 0.0707149 0.0343792 -0.0707119 0.0 +42 2.55 2.65 131.25 -0.180513 -0.166858 0.180388 0.1322 0.16692 -0.132248 0.0 +43 2.55 2.65 138.75 -0.300448 -0.291041 0.300451 0.178321 0.291015 -0.178345 0.0 +44 2.55 2.65 146.25 -0.45666 -0.451363 0.456715 0.239144 0.451427 -0.239145 0.0 +45 2.55 2.65 153.75 -0.684349 -0.67857 0.684481 0.332093 0.678651 -0.332112 0.0 +46 2.55 2.65 161.25 -0.966732 -0.954719 0.966651 0.448833 0.954615 -0.448783 0.0 +47 2.55 2.65 168.75 -1.23353 -1.21297 1.23383 0.558954 1.21297 -0.558949 0.0 +48 2.55 2.65 176.25 -1.39695 -1.37031 1.39698 0.626037 1.37022 -0.625967 0.0 +49 2.55 2.75 3.75 -668.413 -701.057 668.413 15096.3 701.057 -15096.3 0.0 +50 2.55 2.75 11.25 -452.8 -464.411 452.8 5130.32 464.411 -5130.32 0.0 +51 2.55 2.75 18.75 -256.012 -246.87 256.012 1797.07 246.87 -1797.07 0.0 +52 2.55 2.75 26.25 -123.333 -105.643 123.333 565.052 105.643 -565.052 0.0 +53 2.55 2.75 33.75 -50.2709 -35.7913 50.2709 144.93 35.7913 -144.93 0.0 +54 2.55 2.75 41.25 -16.78 -9.69921 16.78 28.1038 9.69923 -28.1038 0.0 +55 2.55 2.75 48.75 -4.12155 -2.37411 4.12164 3.76214 2.3741 -3.76217 0.0 +56 2.55 2.75 56.25 -0.484016 -0.658362 0.484128 0.146857 0.658338 -0.146846 0.0 +57 2.55 2.75 63.75 0.0687647 -0.20106 -0.0687734 -0.260534 0.20103 0.260497 0.0 +58 2.55 2.75 71.25 -0.00147066 -0.0603687 0.0015277 -0.268714 0.0604159 0.268722 0.0 +59 2.55 2.75 78.75 0.0156999 0.0125791 -0.0159656 -0.252993 -0.0125614 0.252974 0.0 +60 2.55 2.75 86.25 0.136925 0.119249 -0.13684 -0.269725 -0.11924 0.269725 0.0 +61 2.55 2.75 93.75 0.247327 0.234358 -0.247334 -0.272826 -0.234332 0.272827 0.0 +62 2.55 2.75 101.25 0.281753 0.286511 -0.281826 -0.224691 -0.286549 0.224691 0.0 +63 2.55 2.75 108.75 0.226138 0.242659 -0.226349 -0.131815 -0.24272 0.131841 0.0 +64 2.55 2.75 116.25 0.106433 0.12752 -0.10664 -0.0258695 -0.127594 0.0258609 0.0 +65 2.55 2.75 123.75 -0.0277616 -0.00630627 0.0276778 0.0615222 0.00630865 -0.0614969 0.0 +66 2.55 2.75 131.25 -0.142446 -0.124893 0.142414 0.118979 0.124975 -0.11903 0.0 +67 2.55 2.75 138.75 -0.248783 -0.237903 0.248779 0.161562 0.237995 -0.161575 0.0 +68 2.55 2.75 146.25 -0.392668 -0.385233 0.392627 0.216964 0.385134 -0.21689 0.0 +69 2.55 2.75 153.75 -0.606858 -0.595071 0.606818 0.302592 0.595088 -0.302606 0.0 +70 2.55 2.75 161.25 -0.874793 -0.851019 0.874799 0.411383 0.850969 -0.411357 0.0 +71 2.55 2.75 168.75 -1.12893 -1.0911 1.12904 0.514712 1.09102 -0.514675 0.0 +72 2.55 2.75 176.25 -1.28457 -1.23755 1.28455 0.577854 1.23747 -0.577828 0.0 +73 2.55 2.85 3.75 -540.757 -671.949 540.757 11232.9 671.949 -11232.9 0.0 +74 2.55 2.85 11.25 -358.962 -456.955 358.962 4626.32 456.955 -4626.32 0.0 +75 2.55 2.85 18.75 -189.205 -242.387 189.205 1670.73 242.387 -1670.73 0.0 +76 2.55 2.85 26.25 -82.3789 -101.034 82.3789 518.217 101.034 -518.217 0.0 +77 2.55 2.85 33.75 -30.0098 -32.1026 30.0098 126.998 32.1025 -126.998 0.0 +78 2.55 2.85 41.25 -9.21751 -7.56922 9.21749 22.2838 7.5692 -22.2838 0.0 +79 2.55 2.85 48.75 -2.28489 -1.50529 2.28485 2.35574 1.50529 -2.35573 0.0 +80 2.55 2.85 56.25 -0.358049 -0.489852 0.357948 0.0188984 0.489874 -0.0189109 0.0 +81 2.55 2.85 63.75 -0.00522043 -0.307792 0.00494878 -0.134592 0.307776 0.134574 0.0 +82 2.55 2.85 71.25 0.00323495 -0.2024 -0.00313048 -0.169997 0.202387 0.169981 0.0 +83 2.55 2.85 78.75 0.0415278 -0.0778296 -0.0414056 -0.213315 0.077898 0.213326 0.0 +84 2.55 2.85 86.25 0.131889 0.069504 -0.132199 -0.248098 -0.0695577 0.248098 0.0 +85 2.55 2.85 93.75 0.214594 0.193542 -0.214655 -0.244475 -0.193398 0.244477 0.0 +86 2.55 2.85 101.25 0.244494 0.247624 -0.244635 -0.195685 -0.247697 0.195696 0.0 +87 2.55 2.85 108.75 0.201434 0.218545 -0.201617 -0.114828 -0.218615 0.114846 0.0 +88 2.55 2.85 116.25 0.0998591 0.127904 -0.0997024 -0.024899 -0.127956 0.0249269 0.0 +89 2.55 2.85 123.75 -0.0181479 0.0163555 0.0181766 0.049407 -0.0163067 -0.0494209 0.0 +90 2.55 2.85 131.25 -0.11898 -0.0876934 0.119352 0.098005 0.0875449 -0.0979311 0.0 +91 2.55 2.85 138.75 -0.214707 -0.191866 0.214605 0.134596 0.191898 -0.13457 0.0 +92 2.55 2.85 146.25 -0.347993 -0.330815 0.348041 0.185048 0.330869 -0.185107 0.0 +93 2.55 2.85 153.75 -0.550177 -0.528952 0.549981 0.265291 0.528797 -0.265232 0.0 +94 2.55 2.85 161.25 -0.804311 -0.769737 0.804194 0.367848 0.769696 -0.367861 0.0 +95 2.55 2.85 168.75 -1.04529 -0.994652 1.04554 0.465186 0.99499 -0.465282 0.0 +96 2.55 2.85 176.25 -1.19281 -1.13166 1.19305 0.52457 1.13177 -0.524594 0.0 +97 2.55 2.95 3.75 -419.502 -582.296 419.502 8332.23 582.296 -8332.23 0.0 +98 2.55 2.95 11.25 -271.55 -404.417 271.55 3930.48 404.417 -3930.48 0.0 +99 2.55 2.95 18.75 -130.928 -214.969 130.928 1464.2 214.969 -1464.2 0.0 +100 2.55 2.95 26.25 -48.786 -88.4342 48.786 447.646 88.4342 -447.646 0.0 +101 2.55 2.95 33.75 -14.3964 -27.3665 14.3964 104.519 27.3665 -104.519 0.0 +102 2.55 2.95 41.25 -3.7883 -6.20808 3.78827 16.4944 6.20806 -16.4944 0.0 +103 2.55 2.95 48.75 -1.0529 -1.19869 1.05292 1.27167 1.19863 -1.27161 0.0 +104 2.55 2.95 56.25 -0.231522 -0.429682 0.231513 -0.0951674 0.429629 0.0951268 0.0 +105 2.55 2.95 63.75 0.0181127 -0.325032 -0.0180919 -0.110423 0.324922 0.110426 0.0 +106 2.55 2.95 71.25 0.049094 -0.246096 -0.0491496 -0.144969 0.245996 0.14495 0.0 +107 2.55 2.95 78.75 0.063364 -0.114463 -0.0633467 -0.196803 0.114426 0.196797 0.0 +108 2.55 2.95 86.25 0.11583 0.0385036 -0.115786 -0.223948 -0.0384687 0.223952 0.0 +109 2.55 2.95 93.75 0.177943 0.156855 -0.178064 -0.209887 -0.156845 0.209889 0.0 +110 2.55 2.95 101.25 0.207654 0.212381 -0.207593 -0.163549 -0.212444 0.163567 0.0 +111 2.55 2.95 108.75 0.175031 0.201414 -0.174609 -0.0967898 -0.20124 0.0967398 0.0 +112 2.55 2.95 116.25 0.0862557 0.136066 -0.0862066 -0.0233966 -0.13596 0.0233258 0.0 +113 2.55 2.95 123.75 -0.0191239 0.0441682 0.0193287 0.0382847 -0.0441811 -0.0382953 0.0 +114 2.55 2.95 131.25 -0.110069 -0.050979 0.109801 0.0798251 0.0509319 -0.0799025 0.0 +115 2.55 2.95 138.75 -0.196213 -0.153394 0.196102 0.113373 0.153405 -0.113396 0.0 +116 2.55 2.95 146.25 -0.318885 -0.291367 0.319145 0.161467 0.291373 -0.161505 0.0 +117 2.55 2.95 153.75 -0.50686 -0.483737 0.506732 0.236963 0.48342 -0.236818 0.0 +118 2.55 2.95 161.25 -0.742764 -0.712982 0.742837 0.331712 0.713077 -0.331758 0.0 +119 2.55 2.95 168.75 -0.965814 -0.924655 0.965837 0.420445 0.924729 -0.420487 0.0 +120 2.55 2.95 176.25 -1.10185 -1.05258 1.10198 0.474136 1.05241 -0.474051 0.0 +121 2.55 3.05 3.75 -319.111 -440.938 319.111 6126.66 440.938 -6126.66 0.0 +122 2.55 3.05 11.25 -200.795 -309.049 200.795 3169.23 309.049 -3169.23 0.0 +123 2.55 3.05 18.75 -86.7152 -162.683 86.7152 1211.49 162.683 -1211.49 0.0 +124 2.55 3.05 26.25 -24.7922 -65.0953 24.7921 363.733 65.0953 -363.733 0.0 +125 2.55 3.05 33.75 -3.79557 -19.4403 3.79568 80.4622 19.4403 -80.4622 0.0 +126 2.55 3.05 41.25 -0.227488 -4.40816 0.227381 11.3442 4.40812 -11.3442 0.0 +127 2.55 3.05 48.75 -0.215962 -0.9846 0.21623 0.572809 0.984607 -0.572833 0.0 +128 2.55 3.05 56.25 -0.0972827 -0.406271 0.0971886 -0.155442 0.406388 0.155438 0.0 +129 2.55 3.05 63.75 0.0474691 -0.320721 -0.0473142 -0.115525 0.320742 0.115541 0.0 +130 2.55 3.05 71.25 0.0542543 -0.274312 -0.0545515 -0.127569 0.274174 0.127517 0.0 +131 2.55 3.05 78.75 0.0439985 -0.158092 -0.0440511 -0.165185 0.158055 0.165194 0.0 +132 2.55 3.05 86.25 0.0821507 -0.00877884 -0.0821081 -0.183829 0.00887135 0.183832 0.0 +133 2.55 3.05 93.75 0.142245 0.109192 -0.142406 -0.168613 -0.109223 0.168609 0.0 +134 2.55 3.05 101.25 0.176786 0.175042 -0.176859 -0.131259 -0.174989 0.13127 0.0 +135 2.55 3.05 108.75 0.153044 0.185839 -0.153188 -0.0796497 -0.185913 0.0796723 0.0 +136 2.55 3.05 116.25 0.0762661 0.144574 -0.0760233 -0.0213083 -0.14475 0.0213947 0.0 +137 2.55 3.05 123.75 -0.0153973 0.0697421 0.0151775 0.0294442 -0.0697414 -0.0295136 0.0 +138 2.55 3.05 131.25 -0.0914496 -0.0164558 0.0915457 0.0650391 0.01638 -0.0650155 0.0 +139 2.55 3.05 138.75 -0.163525 -0.114278 0.163505 0.0952572 0.113968 -0.0951433 0.0 +140 2.55 3.05 146.25 -0.267879 -0.245016 0.267903 0.138326 0.244925 -0.138338 0.0 +141 2.55 3.05 153.75 -0.430018 -0.423265 0.429956 0.203867 0.423326 -0.203942 0.0 +142 2.55 3.05 161.25 -0.633833 -0.631774 0.634037 0.284186 0.631568 -0.284063 0.0 +143 2.55 3.05 168.75 -0.826685 -0.82183 0.826375 0.358252 0.82172 -0.358225 0.0 +144 2.55 3.05 176.25 -0.943422 -0.93572 0.943723 0.402697 0.935847 -0.402743 0.0 +145 2.55 3.15 3.75 -249.767 -271.418 249.767 4425.44 271.418 -4425.44 0.0 +146 2.55 3.15 11.25 -154.5 -187.982 154.5 2434.18 187.982 -2434.18 0.0 +147 2.55 3.15 18.75 -60.5981 -94.4639 60.5982 946.499 94.4639 -946.499 0.0 +148 2.55 3.15 26.25 -11.8534 -34.6155 11.8535 277.025 34.6156 -277.025 0.0 +149 2.55 3.15 33.75 1.6123 -9.2646 -1.61231 57.3974 9.26465 -57.3974 0.0 +150 2.55 3.15 41.25 1.60158 -2.19805 -1.60158 7.12692 2.19808 -7.12698 0.0 +151 2.55 3.15 48.75 0.26948 -0.778894 -0.269488 0.21063 0.778852 -0.210617 0.0 +152 2.55 3.15 56.25 -0.01372 -0.412911 0.0136807 -0.142081 0.412893 0.142164 0.0 +153 2.55 3.15 63.75 0.0224038 -0.329718 -0.0222862 -0.0965871 0.329602 0.096574 0.0 +154 2.55 3.15 71.25 0.0060749 -0.316094 -0.00598008 -0.0883032 0.316076 0.0883122 0.0 +155 2.55 3.15 78.75 0.00302628 -0.219142 -0.00292645 -0.117193 0.219165 0.117188 0.0 +156 2.55 3.15 86.25 0.0523024 -0.0705546 -0.0522252 -0.136651 0.0705734 0.136649 0.0 +157 2.55 3.15 93.75 0.115651 0.0544573 -0.11564 -0.126319 -0.0545821 0.126326 0.0 +158 2.55 3.15 101.25 0.148969 0.134261 -0.149041 -0.0986894 -0.134289 0.0986837 0.0 +159 2.55 3.15 108.75 0.128464 0.165022 -0.12849 -0.0608071 -0.165301 0.0608822 0.0 +160 2.55 3.15 116.25 0.0654112 0.144738 -0.0648575 -0.0171687 -0.144771 0.0172192 0.0 +161 2.55 3.15 123.75 -0.00700089 0.0874701 0.0070514 0.0212287 -0.087399 -0.0213181 0.0 +162 2.55 3.15 131.25 -0.0630668 0.0158432 0.0629726 0.0481408 -0.0158028 -0.0482207 0.0 +163 2.55 3.15 138.75 -0.113207 -0.0669731 0.112947 0.0710475 0.0668196 -0.0709779 0.0 +164 2.55 3.15 146.25 -0.189616 -0.177294 0.189595 0.103802 0.177145 -0.103761 0.0 +165 2.55 3.15 153.75 -0.313405 -0.326317 0.313385 0.153359 0.326249 -0.1534 0.0 +166 2.55 3.15 161.25 -0.471349 -0.499401 0.471384 0.2136 0.499615 -0.213641 0.0 +167 2.55 3.15 168.75 -0.621738 -0.656501 0.621526 0.268765 0.656234 -0.268609 0.0 +168 2.55 3.15 176.25 -0.713168 -0.750131 0.713075 0.301728 0.749961 -0.301587 0.0 +169 2.55 3.25 3.75 -215.533 -105.036 215.533 3115.64 105.036 -3115.64 0.0 +170 2.55 3.25 11.25 -135.709 -66.1673 135.709 1782.43 66.1673 -1782.43 0.0 +171 2.55 3.25 18.75 -53.5226 -25.2778 53.5226 697.12 25.2777 -697.12 0.0 +172 2.55 3.25 26.25 -9.76548 -4.05586 9.76548 196.405 4.05587 -196.405 0.0 +173 2.55 3.25 33.75 2.26986 0.661867 -2.26987 37.2172 -0.661895 -37.2172 0.0 +174 2.55 3.25 41.25 1.94008 -0.139655 -1.94016 3.90169 0.139693 -3.90171 0.0 +175 2.55 3.25 48.75 0.433581 -0.598298 -0.433653 0.0713369 0.598313 -0.071257 0.0 +176 2.55 3.25 56.25 -0.0110448 -0.396733 0.0111185 -0.0792235 0.396666 0.0791487 0.0 +177 2.55 3.25 63.75 -0.0512665 -0.306617 0.0511183 -0.0540821 0.306458 0.05412 0.0 +178 2.55 3.25 71.25 -0.0567327 -0.327807 0.0568023 -0.042547 0.327783 0.0424758 0.0 +179 2.55 3.25 78.75 -0.0248985 -0.256832 0.0248957 -0.0738229 0.256924 0.073814 0.0 +180 2.55 3.25 86.25 0.03699 -0.115693 -0.0368212 -0.0949395 0.115771 0.0949412 0.0 +181 2.55 3.25 93.75 0.088578 0.0114051 -0.0885974 -0.0851166 -0.0114329 0.0851098 0.0 +182 2.55 3.25 101.25 0.108379 0.100211 -0.108454 -0.0631833 -0.100386 0.0632103 0.0 +183 2.55 3.25 108.75 0.0905494 0.146067 -0.0902676 -0.0380134 -0.146103 0.0380456 0.0 +184 2.55 3.25 116.25 0.0446648 0.143011 -0.0447651 -0.0105656 -0.143148 0.0105849 0.0 +185 2.55 3.25 123.75 -0.00397982 0.102972 0.00398606 0.0132778 -0.103051 -0.0132872 0.0 +186 2.55 3.25 131.25 -0.0396488 0.0470538 0.0395149 0.0295482 -0.0468879 -0.0296284 0.0 +187 2.55 3.25 138.75 -0.0696427 -0.0184498 0.0696581 0.0434558 0.0182276 -0.0433637 0.0 +188 2.55 3.25 146.25 -0.118295 -0.104198 0.11835 0.0645889 0.104105 -0.0645169 0.0 +189 2.55 3.25 153.75 -0.201226 -0.219646 0.201381 0.0977209 0.219776 -0.0977906 0.0 +190 2.55 3.25 161.25 -0.310278 -0.35328 0.310501 0.138558 0.353454 -0.138633 0.0 +191 2.55 3.25 168.75 -0.415467 -0.474235 0.415053 0.176198 0.474086 -0.176145 0.0 +192 2.55 3.25 176.25 -0.479006 -0.546119 0.479273 0.198749 0.546279 -0.198787 0.0 +193 2.55 3.35 3.75 -204.898 28.1648 204.898 2043.28 -28.1648 -2043.28 0.0 +194 2.55 3.35 11.25 -135.949 31.6213 135.949 1195.68 -31.6213 -1195.68 0.0 +195 2.55 3.35 18.75 -60.0294 29.3309 60.0294 464.081 -29.3309 -464.081 0.0 +196 2.55 3.35 26.25 -15.5602 19.1482 15.5602 123.342 -19.1482 -123.342 0.0 +197 2.55 3.35 33.75 -0.516502 7.80361 0.516464 20.3914 -7.80361 -20.3915 0.0 +198 2.55 3.35 41.25 1.1959 1.28099 -1.1959 1.61912 -1.28089 -1.61917 0.0 +199 2.55 3.35 48.75 0.338664 -0.427486 -0.338735 0.0672361 0.427458 -0.0671949 0.0 +200 2.55 3.35 56.25 -0.0712654 -0.32692 0.0713186 -0.00513307 0.326996 0.00515152 0.0 +201 2.55 3.35 63.75 -0.121975 -0.24598 0.122164 -0.0158901 0.24595 0.0159275 0.0 +202 2.55 3.35 71.25 -0.0836168 -0.3049 0.0833968 -0.0145822 0.304962 0.0145084 0.0 +203 2.55 3.35 78.75 -0.0227775 -0.26582 0.0226797 -0.0466388 0.265827 0.0466007 0.0 +204 2.55 3.35 86.25 0.0253278 -0.141365 -0.0252494 -0.0598516 0.14135 0.0598496 0.0 +205 2.55 3.35 93.75 0.0478277 -0.0194912 -0.0477364 -0.0442668 0.01948 0.0442715 0.0 +206 2.55 3.35 101.25 0.0542989 0.072706 -0.0542353 -0.0265114 -0.0727603 0.0265457 0.0 +207 2.55 3.35 108.75 0.0474436 0.128762 -0.0473722 -0.0142292 -0.128667 0.0141884 0.0 +208 2.55 3.35 116.25 0.024829 0.139676 -0.0246836 -0.00238193 -0.139623 0.00240878 0.0 +209 2.55 3.35 123.75 -0.00477975 0.112522 0.00457921 0.00880631 -0.112295 -0.00892129 0.0 +210 2.55 3.35 131.25 -0.0290626 0.0670303 0.0288612 0.0167144 -0.0668681 -0.0167711 0.0 +211 2.55 3.35 138.75 -0.0488435 0.012812 0.048558 0.0234532 -0.0126738 -0.0236424 0.0 +212 2.55 3.35 146.25 -0.0762617 -0.0554933 0.0763255 0.0346659 0.0553813 -0.0346319 0.0 +213 2.55 3.35 153.75 -0.123726 -0.144228 0.123766 0.053841 0.144227 -0.0538008 0.0 +214 2.55 3.35 161.25 -0.18791 -0.245407 0.187929 0.078822 0.245764 -0.079086 0.0 +215 2.55 3.35 168.75 -0.251038 -0.336304 0.251286 0.102654 0.336317 -0.102638 0.0 +216 2.55 3.35 176.25 -0.29084 -0.390314 0.290697 0.117217 0.390531 -0.11737 0.0 +217 2.55 3.45 3.75 -160.11 78.3904 160.11 964.746 -78.3904 -964.746 0.0 +218 2.55 3.45 11.25 -112.253 65.2155 112.253 569.896 -65.2155 -569.896 0.0 +219 2.55 3.45 18.75 -55.5875 44.2652 55.5876 216.275 -44.2652 -216.275 0.0 +220 2.55 3.45 26.25 -18.577 23.1948 18.5771 52.7785 -23.1948 -52.7785 0.0 +221 2.55 3.45 33.75 -3.3749 8.35207 3.37496 7.08855 -8.35205 -7.08857 0.0 +222 2.55 3.45 41.25 0.0558271 1.43995 -0.0557888 0.416872 -1.44003 -0.416798 0.0 +223 2.55 3.45 48.75 0.0736874 -0.250918 -0.0736577 0.137694 0.25083 -0.137688 0.0 +224 2.55 3.45 56.25 -0.118382 -0.234235 0.118498 0.029723 0.234224 -0.0297093 0.0 +225 2.55 3.45 63.75 -0.103993 -0.193692 0.103998 -0.0111831 0.193659 0.0111847 0.0 +226 2.55 3.45 71.25 -0.0373239 -0.248873 0.0374 -0.0103758 0.248904 0.0103568 0.0 +227 2.55 3.45 78.75 -0.000815577 -0.221711 0.000857674 -0.0239127 0.221702 0.0239331 0.0 +228 2.55 3.45 86.25 0.00235137 -0.12606 -0.00247045 -0.0235691 0.126024 0.0235785 0.0 +229 2.55 3.45 93.75 0.000693468 -0.0322758 -0.000731622 -0.0100368 0.0322426 0.0100472 0.0 +230 2.55 3.45 101.25 0.0107898 0.0378694 -0.0109773 -0.00230259 -0.0379779 0.00230944 0.0 +231 2.55 3.45 108.75 0.0223901 0.0828189 -0.0224924 -0.0011966 -0.0828617 0.00119886 0.0 +232 2.55 3.45 116.25 0.01901 0.0976112 -0.0189845 0.000576941 -0.0977212 -0.000592258 0.0 +233 2.55 3.45 123.75 0.0023177 0.0865526 -0.00220076 0.00381654 -0.0867258 -0.00376165 0.0 +234 2.55 3.45 131.25 -0.0137084 0.0618094 0.0137112 0.00514774 -0.0618168 -0.00513733 0.0 +235 2.55 3.45 138.75 -0.0208603 0.0307928 0.0209021 0.00395318 -0.0306512 -0.00401619 0.0 +236 2.55 3.45 146.25 -0.0246671 -0.00894626 0.0246851 0.00351226 0.00893543 -0.0035253 0.0 +237 2.55 3.45 153.75 -0.0354818 -0.0611658 0.0352745 0.0074458 0.0613979 -0.00758451 0.0 +238 2.55 3.45 161.25 -0.0568268 -0.12175 0.0568015 0.016221 0.121744 -0.0162267 0.0 +239 2.55 3.45 168.75 -0.0825887 -0.177017 0.0826212 0.0265372 0.177062 -0.0266112 0.0 +240 2.55 3.45 176.25 -0.100362 -0.210215 0.100363 0.0334528 0.210225 -0.0334721 0.0 +241 2.55 3.55 3.75 -78.9919 44.1593 78.9919 272.44 -44.1593 -272.44 0.0 +242 2.55 3.55 11.25 -57.4405 35.3664 57.4405 160.985 -35.3664 -160.985 0.0 +243 2.55 3.55 18.75 -30.4327 22.6574 30.4327 59.1789 -22.6574 -59.1789 0.0 +244 2.55 3.55 26.25 -11.3918 11.2259 11.3918 13.1796 -11.2259 -13.1796 0.0 +245 2.55 3.55 33.75 -2.72329 3.8781 2.7233 1.57893 -3.87813 -1.57891 0.0 +246 2.55 3.55 41.25 -0.349405 0.648596 0.349417 0.278163 -0.648614 -0.278143 0.0 +247 2.55 3.55 48.75 -0.0951034 -0.129698 0.0950942 0.144918 0.129704 -0.144907 0.0 +248 2.55 3.55 56.25 -0.0904303 -0.132617 0.0904025 -0.000622582 0.13263 0.000613981 0.0 +249 2.55 3.55 63.75 -0.0258623 -0.110734 0.0258374 -0.0284537 0.110749 0.0284432 0.0 +250 2.55 3.55 71.25 0.0130336 -0.121492 -0.0129784 -0.00958708 0.121519 0.0095864 0.0 +251 2.55 3.55 78.75 0.00216509 -0.0947175 -0.00212262 -0.00146876 0.0947229 0.0014866 0.0 +252 2.55 3.55 86.25 -0.0193046 -0.044118 0.0193305 0.000949206 0.0440946 -0.000951166 0.0 +253 2.55 3.55 93.75 -0.0204643 -0.00523306 0.0203838 0.00128217 0.00527308 -0.00128181 0.0 +254 2.55 3.55 101.25 -0.00377452 0.0162146 0.00374878 -0.00203826 -0.0161878 0.00203335 0.0 +255 2.55 3.55 108.75 0.0103855 0.0283922 -0.0103646 -0.00590355 -0.0284035 0.0059097 0.0 +256 2.55 3.55 116.25 0.0107496 0.0355757 -0.0107487 -0.00748469 -0.0355346 0.00746902 0.0 +257 2.55 3.55 123.75 0.00390058 0.039282 -0.00394485 -0.00836899 -0.0392871 0.00836606 0.0 +258 2.55 3.55 131.25 0.00302193 0.0417158 -0.00303302 -0.0116169 -0.0417316 0.0116365 0.0 +259 2.55 3.55 138.75 0.0132809 0.0429902 -0.0132594 -0.0177461 -0.0429583 0.0177101 0.0 +260 2.55 3.55 146.25 0.0286472 0.040296 -0.0286569 -0.0242602 -0.0403293 0.0242749 0.0 +261 2.55 3.55 153.75 0.0390318 0.0306394 -0.039064 -0.0280589 -0.0306446 0.028059 0.0 +262 2.55 3.55 161.25 0.0394296 0.0147367 -0.0394103 -0.0279664 -0.0146398 0.0279268 0.0 +263 2.55 3.55 168.75 0.0324474 -0.00226708 -0.0324635 -0.0253945 0.00220765 0.0254368 0.0 +264 2.55 3.55 176.25 0.025994 -0.013213 -0.0260157 -0.0230769 0.0131899 0.0230844 0.0 +265 2.55 3.65 3.75 -10.2735 4.76327 10.2735 20.7201 -4.76327 -20.7201 0.0 +266 2.55 3.65 11.25 -7.59679 3.74938 7.59679 12.2716 -3.74938 -12.2716 0.0 +267 2.55 3.65 18.75 -4.13373 2.33527 4.13373 4.48711 -2.33527 -4.48711 0.0 +268 2.55 3.65 26.25 -1.60809 1.11951 1.60809 1.05798 -1.11951 -1.05798 0.0 +269 2.55 3.65 33.75 -0.426582 0.367384 0.426586 0.237798 -0.367384 -0.237797 0.0 +270 2.55 3.65 41.25 -0.0923209 0.0481501 0.0923222 0.103116 -0.0481492 -0.103116 0.0 +271 2.55 3.65 48.75 -0.0403716 -0.019861 0.0403721 0.0289419 0.0198609 -0.0289447 0.0 +272 2.55 3.65 56.25 -0.0181588 -0.0104242 0.018157 -0.0111623 0.010423 0.0111643 0.0 +273 2.55 3.65 63.75 0.0026199 -0.0022943 -0.00261809 -0.0112332 0.00229608 0.011234 0.0 +274 2.55 3.65 71.25 0.00555137 -0.00054609 -0.00554585 -0.000901878 0.000542356 0.000901001 0.0 +275 2.55 3.65 78.75 -0.00349077 0.00348611 0.00348128 0.00388527 -0.0034823 -0.00388526 0.0 +276 2.55 3.65 86.25 -0.00986876 0.00759326 0.00986851 0.00334418 -0.00759374 -0.00334402 0.0 +277 2.55 3.65 93.75 -0.00861045 0.00735376 0.00861467 0.000656354 -0.00735444 -0.000656104 0.0 +278 2.55 3.65 101.25 -0.00414524 0.00377925 0.00414321 -0.00212584 -0.00377449 0.00212561 0.0 +279 2.55 3.65 108.75 -0.00169477 0.000439308 0.00169322 -0.00396038 -0.000442715 0.00396063 0.0 +280 2.55 3.65 116.25 -0.00201868 -0.000719026 0.00201981 -0.0047974 0.000729887 0.00479364 0.0 +281 2.55 3.65 123.75 -0.0022902 0.000305603 0.00229371 -0.00529632 -0.000307648 0.00529785 0.0 +282 2.55 3.65 131.25 6.5658e-05 0.00293592 -6.35245e-05 -0.00609152 -0.00294529 0.00609664 0.0 +283 2.55 3.65 138.75 0.00496513 0.00653024 -0.0049612 -0.00723673 -0.00653204 0.00723752 0.0 +284 2.55 3.65 146.25 0.0100844 0.0103162 -0.0100899 -0.0082568 -0.0103134 0.00825192 0.0 +285 2.55 3.65 153.75 0.013056 0.0135185 -0.0130568 -0.00863418 -0.0135186 0.00863497 0.0 +286 2.55 3.65 161.25 0.0130732 0.0156428 -0.013084 -0.00825131 -0.0156473 0.00825326 0.0 +287 2.55 3.65 168.75 0.0112797 0.0167179 -0.0112803 -0.00747124 -0.0167224 0.00747658 0.0 +288 2.55 3.65 176.25 0.0096521 0.0170897 -0.00964981 -0.00687278 -0.0170876 0.00686999 0.0 +289 2.65 2.55 3.75 -799.674 -712.655 799.674 18807.8 712.655 -18807.8 0.0 +290 2.65 2.55 11.25 -525.625 -475.265 525.625 4994.59 475.265 -4994.59 0.0 +291 2.65 2.55 18.75 -295.846 -269.889 295.846 1679.59 269.889 -1679.59 0.0 +292 2.65 2.55 26.25 -143.669 -131.164 143.669 522.387 131.164 -522.387 0.0 +293 2.65 2.55 33.75 -60.2595 -54.4807 60.2595 136.208 54.4807 -136.208 0.0 +294 2.65 2.55 41.25 -21.6186 -19.006 21.6186 29.1359 19.006 -29.1359 0.0 +295 2.65 2.55 48.75 -6.2004 -4.98522 6.20039 5.36148 4.98526 -5.3615 0.0 +296 2.65 2.55 56.25 -0.973428 -0.39018 0.973324 0.482318 0.390219 -0.482323 0.0 +297 2.65 2.55 63.75 0.314211 0.536906 -0.314193 -0.589646 -0.536928 0.58965 0.0 +298 2.65 2.55 71.25 0.35202 0.378507 -0.352079 -0.582078 -0.378534 0.582099 0.0 +299 2.65 2.55 78.75 0.201526 0.217522 -0.201635 -0.39221 -0.217499 0.392213 0.0 +300 2.65 2.55 86.25 0.158101 0.284677 -0.15805 -0.345984 -0.284628 0.345996 0.0 +301 2.65 2.55 93.75 0.194955 0.4204 -0.194905 -0.359053 -0.420368 0.359041 0.0 +302 2.65 2.55 101.25 0.217278 0.451611 -0.217168 -0.302903 -0.451706 0.302904 0.0 +303 2.65 2.55 108.75 0.177459 0.346261 -0.177385 -0.174633 -0.34637 0.174667 0.0 +304 2.65 2.55 116.25 0.0932406 0.177749 -0.093405 -0.0419077 -0.177758 0.0419259 0.0 +305 2.65 2.55 123.75 0.0143374 0.03145 -0.0145507 0.0454119 -0.0313795 -0.045448 0.0 +306 2.65 2.55 131.25 -0.0346536 -0.0608535 0.0348124 0.0869938 0.0609483 -0.0870298 0.0 +307 2.65 2.55 138.75 -0.0817334 -0.132275 0.0817107 0.117066 0.132252 -0.11706 0.0 +308 2.65 2.55 146.25 -0.184555 -0.244924 0.18477 0.173455 0.244919 -0.173443 0.0 +309 2.65 2.55 153.75 -0.380746 -0.438659 0.380787 0.272485 0.438786 -0.272543 0.0 +310 2.65 2.55 161.25 -0.649138 -0.696616 0.649172 0.400228 0.696703 -0.400289 0.0 +311 2.65 2.55 168.75 -0.912684 -0.947747 0.912894 0.520664 0.947624 -0.520601 0.0 +312 2.65 2.55 176.25 -1.07651 -1.10339 1.07652 0.593714 1.10339 -0.593746 0.0 +313 2.65 2.65 3.75 -850.9 -766.532 850.9 24206.3 766.532 -24206.3 0.0 +314 2.65 2.65 11.25 -532.471 -481.095 532.471 5590.03 481.095 -5590.03 0.0 +315 2.65 2.65 18.75 -284.368 -250.886 284.368 1834.01 250.886 -1834.01 0.0 +316 2.65 2.65 26.25 -129.075 -106.598 129.075 555.283 106.598 -555.283 0.0 +317 2.65 2.65 33.75 -49.9399 -36.5293 49.9399 138.315 36.5293 -138.315 0.0 +318 2.65 2.65 41.25 -16.5129 -10.4032 16.5129 27.2019 10.4033 -27.2019 0.0 +319 2.65 2.65 48.75 -4.46528 -2.7076 4.46539 4.42411 2.70761 -4.42411 0.0 +320 2.65 2.65 56.25 -0.741021 -0.597377 0.741105 0.305553 0.597353 -0.305549 0.0 +321 2.65 2.65 63.75 0.104606 0.0237456 -0.104669 -0.572899 -0.0237444 0.572894 0.0 +322 2.65 2.65 71.25 0.139391 0.125946 -0.139515 -0.571709 -0.125927 0.571698 0.0 +323 2.65 2.65 78.75 0.104219 0.102894 -0.104113 -0.382665 -0.102882 0.382676 0.0 +324 2.65 2.65 86.25 0.157087 0.145852 -0.157232 -0.297431 -0.1459 0.297442 0.0 +325 2.65 2.65 93.75 0.240407 0.236266 -0.240541 -0.278188 -0.236265 0.27819 0.0 +326 2.65 2.65 101.25 0.275238 0.279291 -0.274988 -0.229799 -0.27936 0.229805 0.0 +327 2.65 2.65 108.75 0.227141 0.229356 -0.227284 -0.134968 -0.229285 0.134932 0.0 +328 2.65 2.65 116.25 0.115892 0.112442 -0.115868 -0.0291153 -0.112422 0.0291383 0.0 +329 2.65 2.65 123.75 -0.010285 -0.0162117 0.0103961 0.0530193 0.0161505 -0.0529991 0.0 +330 2.65 2.65 131.25 -0.1188 -0.124881 0.118875 0.104487 0.124916 -0.104492 0.0 +331 2.65 2.65 138.75 -0.223058 -0.229731 0.223369 0.145724 0.229737 -0.145685 0.0 +332 2.65 2.65 146.25 -0.368701 -0.376052 0.368859 0.205686 0.3761 -0.205685 0.0 +333 2.65 2.65 153.75 -0.587337 -0.594228 0.587423 0.299459 0.594372 -0.299509 0.0 +334 2.65 2.65 161.25 -0.859864 -0.865453 0.859988 0.416736 0.865344 -0.416708 0.0 +335 2.65 2.65 168.75 -1.11756 -1.12156 1.11739 0.526563 1.12147 -0.526502 0.0 +336 2.65 2.65 176.25 -1.2751 -1.27817 1.27506 0.593124 1.2781 -0.593061 0.0 +337 2.65 2.75 3.75 -835.182 -772.341 835.182 21905.9 772.341 -21905.9 0.0 +338 2.65 2.75 11.25 -513.694 -481.73 513.694 5723.06 481.73 -5723.06 0.0 +339 2.65 2.75 18.75 -261.725 -240.477 261.725 1876.13 240.477 -1876.13 0.0 +340 2.65 2.75 26.25 -110.82 -93.042 110.82 555.313 93.0419 -555.313 0.0 +341 2.65 2.75 33.75 -39.2645 -26.3478 39.2645 131.64 26.3478 -131.64 0.0 +342 2.65 2.75 41.25 -11.8937 -5.23302 11.8938 23.3148 5.233 -23.3148 0.0 +343 2.65 2.75 48.75 -3.05671 -0.993603 3.05657 3.14407 0.993621 -3.14406 0.0 +344 2.65 2.75 56.25 -0.550099 -0.358525 0.550227 0.163089 0.358498 -0.163112 0.0 +345 2.65 2.75 63.75 -0.0205929 -0.0842747 0.0205161 -0.407995 0.0842518 0.407956 0.0 +346 2.65 2.75 71.25 0.00336668 0.0345981 -0.00349936 -0.421497 -0.0346157 0.421506 0.0 +347 2.65 2.75 78.75 0.0253619 0.0593683 -0.0255874 -0.3063 -0.0593531 0.306294 0.0 +348 2.65 2.75 86.25 0.119248 0.114375 -0.119305 -0.255219 -0.114285 0.255229 0.0 +349 2.65 2.75 93.75 0.216069 0.202657 -0.216049 -0.241183 -0.202733 0.241187 0.0 +350 2.65 2.75 101.25 0.255314 0.253769 -0.255148 -0.201128 -0.253738 0.20113 0.0 +351 2.65 2.75 108.75 0.214511 0.222856 -0.214525 -0.121963 -0.222827 0.121965 0.0 +352 2.65 2.75 116.25 0.110921 0.123065 -0.110896 -0.0278056 -0.123096 0.027821 0.0 +353 2.65 2.75 123.75 -0.0119931 0.00216882 0.0119589 0.0508731 -0.00227192 -0.0508543 0.0 +354 2.65 2.75 131.25 -0.119575 -0.104676 0.119555 0.102045 0.10466 -0.10204 0.0 +355 2.65 2.75 138.75 -0.220603 -0.205567 0.220425 0.139953 0.205519 -0.139884 0.0 +356 2.65 2.75 146.25 -0.354901 -0.339963 0.354916 0.191191 0.340301 -0.191375 0.0 +357 2.65 2.75 153.75 -0.553233 -0.537535 0.553233 0.27207 0.537478 -0.272051 0.0 +358 2.65 2.75 161.25 -0.800056 -0.783314 0.80005 0.37528 0.783269 -0.375219 0.0 +359 2.65 2.75 168.75 -1.03362 -1.01636 1.03349 0.473222 1.01637 -0.473237 0.0 +360 2.65 2.75 176.25 -1.17633 -1.15917 1.17626 0.532997 1.15938 -0.533141 0.0 +361 2.65 2.85 3.75 -760.67 -716.576 760.67 16548.2 716.576 -16548.2 0.0 +362 2.65 2.85 11.25 -468.577 -458.252 468.577 5405.79 458.252 -5405.79 0.0 +363 2.65 2.85 18.75 -228.053 -226.497 228.053 1802.81 226.497 -1802.81 0.0 +364 2.65 2.85 26.25 -89.1662 -84.2911 89.1663 523.528 84.2911 -523.528 0.0 +365 2.65 2.85 33.75 -28.2756 -21.661 28.2757 117.98 21.661 -117.98 0.0 +366 2.65 2.85 41.25 -7.65848 -3.29349 7.65854 18.6016 3.29345 -18.6016 0.0 +367 2.65 2.85 48.75 -1.87861 -0.425521 1.87855 1.91342 0.425548 -1.91344 0.0 +368 2.65 2.85 56.25 -0.359414 -0.305329 0.359467 0.0202548 0.305288 -0.0202399 0.0 +369 2.65 2.85 63.75 -0.0454417 -0.184956 0.0452869 -0.276244 0.184875 0.276227 0.0 +370 2.65 2.85 71.25 -0.03328 -0.0799704 0.0333967 -0.292345 0.0799691 0.292342 0.0 +371 2.65 2.85 78.75 0.00639036 -0.0189859 -0.006449 -0.241547 0.0190153 0.241563 0.0 +372 2.65 2.85 86.25 0.102068 0.0661345 -0.102071 -0.222916 -0.0661619 0.222919 0.0 +373 2.65 2.85 93.75 0.188697 0.163968 -0.188721 -0.21219 -0.163988 0.212191 0.0 +374 2.65 2.85 101.25 0.22364 0.220472 -0.223377 -0.175014 -0.220473 0.175017 0.0 +375 2.65 2.85 108.75 0.190707 0.202776 -0.190758 -0.106231 -0.202789 0.106247 0.0 +376 2.65 2.85 116.25 0.101112 0.120884 -0.101059 -0.0239388 -0.120905 0.0239052 0.0 +377 2.65 2.85 123.75 -0.00702613 0.0160528 0.00714713 0.0453335 -0.0161052 -0.0453373 0.0 +378 2.65 2.85 131.25 -0.101648 -0.0781261 0.101387 0.088976 0.0781448 -0.0889832 0.0 +379 2.65 2.85 138.75 -0.188841 -0.166223 0.188892 0.119526 0.166146 -0.119525 0.0 +380 2.65 2.85 146.25 -0.306982 -0.284004 0.307036 0.162419 0.283915 -0.162404 0.0 +381 2.65 2.85 153.75 -0.48517 -0.45968 0.485006 0.233515 0.459501 -0.233437 0.0 +382 2.65 2.85 161.25 -0.709159 -0.680393 0.709041 0.326165 0.680286 -0.32613 0.0 +383 2.65 2.85 168.75 -0.921682 -0.890267 0.921631 0.414752 0.89028 -0.414752 0.0 +384 2.65 2.85 176.25 -1.05193 -1.01912 1.05183 0.468933 1.01918 -0.469002 0.0 +385 2.65 2.95 3.75 -652.979 -606.124 652.978 12075.3 606.124 -12075.3 0.0 +386 2.65 2.95 11.25 -403.824 -399.31 403.824 4765.3 399.31 -4765.3 0.0 +387 2.65 2.95 18.75 -187.153 -198.273 187.153 1631.6 198.273 -1631.6 0.0 +388 2.65 2.95 26.25 -66.1445 -73.0744 66.1444 465.712 73.0744 -465.712 0.0 +389 2.65 2.95 33.75 -17.7622 -18.4285 17.7623 99.7601 18.4285 -99.7601 0.0 +390 2.65 2.95 41.25 -3.98999 -2.7919 3.99011 13.9822 2.7919 -13.9822 0.0 +391 2.65 2.95 48.75 -0.962247 -0.422871 0.962286 1.0033 0.422848 -1.00329 0.0 +392 2.65 2.95 56.25 -0.219175 -0.313473 0.218952 -0.0875255 0.313511 0.0875306 0.0 +393 2.65 2.95 63.75 -0.044678 -0.231589 0.0446919 -0.204831 0.231605 0.204882 0.0 +394 2.65 2.95 71.25 -0.0396615 -0.157633 0.0394157 -0.207168 0.15761 0.207183 0.0 +395 2.65 2.95 78.75 0.000394622 -0.0817809 -0.000419789 -0.190543 0.0817504 0.19052 0.0 +396 2.65 2.95 86.25 0.0846769 0.0240518 -0.0846618 -0.190014 -0.0241096 0.19001 0.0 +397 2.65 2.95 93.75 0.158081 0.12764 -0.157821 -0.180645 -0.127555 0.18064 0.0 +398 2.65 2.95 101.25 0.189421 0.189324 -0.189292 -0.147352 -0.189274 0.147358 0.0 +399 2.65 2.95 108.75 0.164176 0.186927 -0.163977 -0.0895019 -0.186952 0.0894983 0.0 +400 2.65 2.95 116.25 0.0871432 0.125207 -0.0868669 -0.0199561 -0.125352 0.0199732 0.0 +401 2.65 2.95 123.75 -0.0085628 0.0365974 0.00860248 0.0390423 -0.0363033 -0.0391 0.0 +402 2.65 2.95 131.25 -0.0923265 -0.0482959 0.0922008 0.0760854 0.0485513 -0.0762079 0.0 +403 2.65 2.95 138.75 -0.169808 -0.131174 0.169899 0.102608 0.131327 -0.10265 0.0 +404 2.65 2.95 146.25 -0.277395 -0.242796 0.277398 0.141394 0.242783 -0.141344 0.0 +405 2.65 2.95 153.75 -0.440501 -0.407224 0.440757 0.205828 0.407133 -0.205796 0.0 +406 2.65 2.95 161.25 -0.645643 -0.610905 0.6459 0.288976 0.611281 -0.289147 0.0 +407 2.65 2.95 168.75 -0.840165 -0.802999 0.840107 0.367747 0.802858 -0.367578 0.0 +408 2.65 2.95 176.25 -0.958665 -0.920072 0.958486 0.415643 0.920088 -0.415608 0.0 +409 2.65 3.05 3.75 -535.332 -454.934 535.332 8760.56 454.934 -8760.56 0.0 +410 2.65 3.05 11.25 -331.494 -306.561 331.494 3960.52 306.561 -3960.52 0.0 +411 2.65 3.05 18.75 -145.715 -152.648 145.715 1393.82 152.648 -1393.82 0.0 +412 2.65 3.05 26.25 -45.1283 -55.696 45.1283 390.806 55.696 -390.806 0.0 +413 2.65 3.05 33.75 -9.03711 -13.9981 9.03714 79.4908 13.9982 -79.4908 0.0 +414 2.65 3.05 41.25 -1.22467 -2.35412 1.22472 9.98439 2.35415 -9.98442 0.0 +415 2.65 3.05 48.75 -0.350067 -0.498445 0.350201 0.482424 0.498397 -0.482377 0.0 +416 2.65 3.05 56.25 -0.145634 -0.296881 0.145625 -0.138328 0.296866 0.138253 0.0 +417 2.65 3.05 63.75 -0.0512301 -0.23938 0.0510461 -0.169789 0.239391 0.169777 0.0 +418 2.65 3.05 71.25 -0.0475131 -0.216688 0.0475797 -0.14914 0.21666 0.149179 0.0 +419 2.65 3.05 78.75 -0.0100019 -0.142708 0.0103876 -0.145447 0.142686 0.145453 0.0 +420 2.65 3.05 86.25 0.0629653 -0.0219697 -0.0630473 -0.155105 0.0219773 0.155114 0.0 +421 2.65 3.05 93.75 0.12664 0.0897788 -0.12658 -0.148638 -0.0897681 0.148648 0.0 +422 2.65 3.05 101.25 0.15677 0.161102 -0.15675 -0.121208 -0.161149 0.121229 0.0 +423 2.65 3.05 108.75 0.13765 0.175494 -0.137742 -0.0739815 -0.175467 0.0739654 0.0 +424 2.65 3.05 116.25 0.0719305 0.132074 -0.0719425 -0.0160117 -0.13204 0.0159808 0.0 +425 2.65 3.05 123.75 -0.0105205 0.0566312 0.0107171 0.0339816 -0.05635 -0.0341083 0.0 +426 2.65 3.05 131.25 -0.0825435 -0.0218324 0.0823353 0.0659987 0.0216974 -0.0659344 0.0 +427 2.65 3.05 138.75 -0.148847 -0.101917 0.149043 0.0897675 0.101945 -0.0897216 0.0 +428 2.65 3.05 146.25 -0.242919 -0.209388 0.242954 0.124121 0.209336 -0.12419 0.0 +429 2.65 3.05 153.75 -0.386426 -0.362461 0.386542 0.179324 0.362431 -0.179385 0.0 +430 2.65 3.05 161.25 -0.566176 -0.547526 0.566298 0.248855 0.547163 -0.248731 0.0 +431 2.65 3.05 168.75 -0.735042 -0.718844 0.735426 0.313712 0.718869 -0.313772 0.0 +432 2.65 3.05 176.25 -0.837976 -0.822371 0.837847 0.352792 0.822288 -0.352789 0.0 +433 2.65 3.15 3.75 -427.355 -285.2 427.355 6295.52 285.2 -6295.52 0.0 +434 2.65 3.15 11.25 -265.153 -194.02 265.153 3125.25 194.02 -3125.25 0.0 +435 2.65 3.15 18.75 -111.202 -95.1726 111.202 1125.35 95.1726 -1125.35 0.0 +436 2.65 3.15 26.25 -29.6517 -33.3268 29.6517 308.747 33.3268 -308.747 0.0 +437 2.65 3.15 33.75 -3.36664 -8.0325 3.36662 59.3209 8.03251 -59.3209 0.0 +438 2.65 3.15 41.25 0.370119 -1.56003 -0.370195 6.73765 1.55997 -6.73765 0.0 +439 2.65 3.15 48.75 -0.0293352 -0.505394 0.0293329 0.248728 0.505409 -0.248723 0.0 +440 2.65 3.15 56.25 -0.105843 -0.270835 0.105751 -0.145765 0.270743 0.145803 0.0 +441 2.65 3.15 63.75 -0.0513317 -0.246866 0.0514241 -0.147382 0.246878 0.147378 0.0 +442 2.65 3.15 71.25 -0.0501128 -0.275431 0.04993 -0.104001 0.275378 0.10398 0.0 +443 2.65 3.15 78.75 -0.0164568 -0.206434 0.0163659 -0.104649 0.206543 0.1047 0.0 +444 2.65 3.15 86.25 0.0461547 -0.0733023 -0.0462363 -0.11996 0.0733698 0.119964 0.0 +445 2.65 3.15 93.75 0.0990004 0.0476562 -0.0990613 -0.115936 -0.0477138 0.115929 0.0 +446 2.65 3.15 101.25 0.124404 0.129396 -0.124624 -0.0943304 -0.129428 0.0943415 0.0 +447 2.65 3.15 108.75 0.110989 0.159191 -0.110618 -0.0576564 -0.159015 0.0576196 0.0 +448 2.65 3.15 116.25 0.0587243 0.132639 -0.0587968 -0.0121644 -0.132721 0.0121638 0.0 +449 2.65 3.15 123.75 -0.00573936 0.071577 0.00545961 0.0272095 -0.0714379 -0.0272703 0.0 +450 2.65 3.15 131.25 -0.0595329 0.00372402 0.0596701 0.0523942 -0.00377444 -0.0523371 0.0 +451 2.65 3.15 138.75 -0.110101 -0.0680458 0.109914 0.0711533 0.0677435 -0.071079 0.0 +452 2.65 3.15 146.25 -0.183484 -0.162436 0.183193 0.097899 0.16187 -0.0976014 0.0 +453 2.65 3.15 153.75 -0.297201 -0.294331 0.297328 0.13994 0.294371 -0.13996 0.0 +454 2.65 3.15 161.25 -0.440022 -0.45053 0.440364 0.191997 0.45081 -0.192128 0.0 +455 2.65 3.15 168.75 -0.573979 -0.593135 0.574118 0.23999 0.593252 -0.240079 0.0 +456 2.65 3.15 176.25 -0.655332 -0.678506 0.655274 0.268714 0.678407 -0.2687 0.0 +457 2.65 3.25 3.75 -343.28 -124.107 343.28 4445.63 124.107 -4445.63 0.0 +458 2.65 3.25 11.25 -215.576 -82.5722 215.576 2350.25 82.5722 -2350.25 0.0 +459 2.65 3.25 18.75 -89.1611 -36.9434 89.1611 858.678 36.9434 -858.678 0.0 +460 2.65 3.25 26.25 -21.9322 -10.3742 21.9323 228.574 10.3742 -228.574 0.0 +461 2.65 3.25 33.75 -1.31403 -1.72106 1.31403 40.8621 1.72107 -40.8621 0.0 +462 2.65 3.25 41.25 0.795648 -0.575902 -0.795697 4.14894 0.57591 -4.14896 0.0 +463 2.65 3.25 48.75 0.0763357 -0.456169 -0.076398 0.148004 0.456256 -0.148065 0.0 +464 2.65 3.25 56.25 -0.063689 -0.249401 0.0637021 -0.13222 0.249531 0.132205 0.0 +465 2.65 3.25 63.75 -0.0358554 -0.249745 0.0359111 -0.121502 0.249724 0.121491 0.0 +466 2.65 3.25 71.25 -0.0428349 -0.311738 0.0428194 -0.0638131 0.311734 0.0637754 0.0 +467 2.65 3.25 78.75 -0.0147141 -0.250034 0.0144509 -0.0678206 0.250075 0.0677768 0.0 +468 2.65 3.25 86.25 0.0352991 -0.11503 -0.0353655 -0.0843742 0.115078 0.0843892 0.0 +469 2.65 3.25 93.75 0.0720144 0.00909964 -0.0719435 -0.0804605 -0.0090581 0.0804531 0.0 +470 2.65 3.25 101.25 0.0888655 0.0989902 -0.0887325 -0.0647524 -0.0990223 0.0647474 0.0 +471 2.65 3.25 108.75 0.0799171 0.143831 -0.0801351 -0.0405357 -0.143865 0.0405626 0.0 +472 2.65 3.25 116.25 0.0463151 0.13551 -0.0462271 -0.0103342 -0.135713 0.0104217 0.0 +473 2.65 3.25 123.75 0.00341445 0.0908375 -0.00340467 0.0161085 -0.0908948 -0.0161034 0.0 +474 2.65 3.25 131.25 -0.0328772 0.0354199 0.0327234 0.0332693 -0.0353895 -0.0333584 0.0 +475 2.65 3.25 138.75 -0.0675007 -0.0244596 0.0674606 0.0466046 0.0245277 -0.0466162 0.0 +476 2.65 3.25 146.25 -0.119973 -0.102745 0.119865 0.0658272 0.102678 -0.0658241 0.0 +477 2.65 3.25 153.75 -0.201674 -0.208813 0.202075 0.0954721 0.209073 -0.0955902 0.0 +478 2.65 3.25 161.25 -0.304347 -0.332116 0.304539 0.131641 0.332258 -0.131649 0.0 +479 2.65 3.25 168.75 -0.400265 -0.443353 0.400058 0.164689 0.443498 -0.164816 0.0 +480 2.65 3.25 176.25 -0.458148 -0.509414 0.458013 0.184384 0.509501 -0.184446 0.0 +481 2.65 3.35 3.75 -278.227 3.35188 278.227 2946.21 -3.35188 -2946.21 0.0 +482 2.65 3.35 11.25 -180.202 7.30679 180.202 1622.2 -7.30679 -1622.2 0.0 +483 2.65 3.35 18.75 -77.9402 10.1339 77.9402 594.724 -10.1339 -594.724 0.0 +484 2.65 3.35 26.25 -20.9467 8.02501 20.9466 151.361 -8.02502 -151.361 0.0 +485 2.65 3.35 33.75 -2.25835 3.3951 2.25826 24.3523 -3.39512 -24.3522 0.0 +486 2.65 3.35 41.25 0.363524 0.335418 -0.363448 2.07799 -0.335341 -2.07804 0.0 +487 2.65 3.35 48.75 0.0599237 -0.367988 -0.059957 0.0931953 0.367953 -0.0931855 0.0 +488 2.65 3.35 56.25 -0.0236982 -0.242143 0.0236458 -0.098598 0.242167 0.0985908 0.0 +489 2.65 3.35 63.75 -0.0239201 -0.250568 0.023879 -0.0793347 0.250659 0.0793004 0.0 +490 2.65 3.35 71.25 -0.0368509 -0.319915 0.0367806 -0.0239745 0.319926 0.0239988 0.0 +491 2.65 3.35 78.75 -0.0110244 -0.268487 0.0110139 -0.0344337 0.268438 0.0344165 0.0 +492 2.65 3.35 86.25 0.0245226 -0.144794 -0.024666 -0.0497857 0.144602 0.0497966 0.0 +493 2.65 3.35 93.75 0.0424081 -0.0251599 -0.0424651 -0.0453306 0.0251858 0.0453233 0.0 +494 2.65 3.35 101.25 0.04903 0.0707895 -0.0493151 -0.0359067 -0.0707318 0.0358776 0.0 +495 2.65 3.35 108.75 0.0471092 0.130164 -0.0471373 -0.0244748 -0.130189 0.0244837 0.0 +496 2.65 3.35 116.25 0.0314376 0.139837 -0.0314698 -0.00916072 -0.139805 0.00913728 0.0 +497 2.65 3.35 123.75 0.00660309 0.109671 -0.00661976 0.00590828 -0.109418 -0.00599612 0.0 +498 2.65 3.35 131.25 -0.0184331 0.0620534 0.0189306 0.0173272 -0.0619207 -0.0174002 0.0 +499 2.65 3.35 138.75 -0.0453275 0.00760214 0.0452428 0.0275525 -0.00734601 -0.027681 0.0 +500 2.65 3.35 146.25 -0.082266 -0.0599492 0.082171 0.0416578 0.0599927 -0.0416724 0.0 +501 2.65 3.35 153.75 -0.136274 -0.146184 0.136402 0.0620795 0.146055 -0.0619743 0.0 +502 2.65 3.35 161.25 -0.202661 -0.24297 0.20278 0.086379 0.243041 -0.0864087 0.0 +503 2.65 3.35 168.75 -0.264667 -0.328848 0.264622 0.108466 0.328816 -0.108439 0.0 +504 2.65 3.35 176.25 -0.302166 -0.379469 0.302333 0.121649 0.379451 -0.121585 0.0 +505 2.65 3.45 3.75 -181.094 56.5768 181.094 1415.07 -56.5768 -1415.07 0.0 +506 2.65 3.45 11.25 -122.646 43.7184 122.646 798.081 -43.7184 -798.081 0.0 +507 2.65 3.45 18.75 -57.6293 27.3547 57.6292 289.903 -27.3547 -289.903 0.0 +508 2.65 3.45 26.25 -18.2701 13.6208 18.2701 69.1213 -13.6207 -69.1213 0.0 +509 2.65 3.45 33.75 -3.43227 4.75555 3.43223 9.49818 -4.75554 -9.49816 0.0 +510 2.65 3.45 41.25 -0.262119 0.743592 0.262138 0.642703 -0.743569 -0.64265 0.0 +511 2.65 3.45 48.75 -0.0206249 -0.220801 0.0206949 0.0833427 0.220803 -0.0833703 0.0 +512 2.65 3.45 56.25 -0.0278092 -0.219147 0.0277268 -0.0418895 0.219207 0.0419362 0.0 +513 2.65 3.45 63.75 -0.0302865 -0.221675 0.0303371 -0.0292143 0.221725 0.0292088 0.0 +514 2.65 3.45 71.25 -0.0283973 -0.257992 0.0284536 0.00362643 0.257937 -0.00359012 0.0 +515 2.65 3.45 78.75 -0.00583895 -0.217814 0.00603552 -0.0105431 0.217741 0.0105389 0.0 +516 2.65 3.45 86.25 0.0119324 -0.129526 -0.0119649 -0.0224338 0.129557 0.0224452 0.0 +517 2.65 3.45 93.75 0.0144366 -0.0428903 -0.0145475 -0.0187179 0.0429014 0.0187299 0.0 +518 2.65 3.45 101.25 0.0149629 0.0297917 -0.015042 -0.0130715 -0.0298841 0.013074 0.0 +519 2.65 3.45 108.75 0.0176727 0.0802808 -0.0176481 -0.00859687 -0.0801128 0.00854075 0.0 +520 2.65 3.45 116.25 0.0142801 0.0968509 -0.0142142 -0.00275531 -0.0968446 0.00279613 0.0 +521 2.65 3.45 123.75 0.00274599 0.0822463 -0.00285046 0.00385754 -0.0822624 -0.00387098 0.0 +522 2.65 3.45 131.25 -0.0115459 0.0508246 0.0116421 0.00941126 -0.0506893 -0.00950556 0.0 +523 2.65 3.45 138.75 -0.0256544 0.0123774 0.0254092 0.0140698 -0.0124329 -0.0139752 0.0 +524 2.65 3.45 146.25 -0.0416502 -0.0338945 0.0416358 0.0199093 0.0339039 -0.0199382 0.0 +525 2.65 3.45 153.75 -0.06548 -0.0902951 0.0654101 0.02876 0.0902214 -0.0286754 0.0 +526 2.65 3.45 161.25 -0.0968618 -0.152516 0.096841 0.0402396 0.152761 -0.0403307 0.0 +527 2.65 3.45 168.75 -0.128132 -0.207768 0.128088 0.0514288 0.207796 -0.0514167 0.0 +528 2.65 3.45 176.25 -0.147889 -0.240577 0.147879 0.058392 0.24052 -0.0584226 0.0 +529 2.65 3.55 3.75 -77.1979 33.0526 77.1979 408.269 -33.0526 -408.269 0.0 +530 2.65 3.55 11.25 -54.4456 24.806 54.4456 233.071 -24.806 -233.071 0.0 +531 2.65 3.55 18.75 -27.4729 14.6982 27.4729 83.0823 -14.6982 -83.0823 0.0 +532 2.65 3.55 26.25 -9.74029 6.98034 9.74028 18.3878 -6.98034 -18.3878 0.0 +533 2.65 3.55 33.75 -2.26688 2.44976 2.26686 2.2212 -2.44975 -2.22122 0.0 +534 2.65 3.55 41.25 -0.338901 0.452784 0.338876 0.250018 -0.452783 -0.250042 0.0 +535 2.65 3.55 48.75 -0.085801 -0.0837087 0.0858276 0.0833161 0.0837009 -0.0833153 0.0 +536 2.65 3.55 56.25 -0.053787 -0.114074 0.0537453 -0.0208865 0.114083 0.0208809 0.0 +537 2.65 3.55 63.75 -0.0249841 -0.102636 0.0249818 -0.0169731 0.102618 0.0169814 0.0 +538 2.65 3.55 71.25 -0.00793484 -0.104993 0.0079199 0.00243536 0.104968 -0.00244121 0.0 +539 2.65 3.55 78.75 0.000477289 -0.083635 -0.000473373 -0.0028304 0.083634 0.00283354 0.0 +540 2.65 3.55 86.25 0.00225691 -0.0484377 -0.00227501 -0.00865479 0.0484012 0.00865592 0.0 +541 2.65 3.55 93.75 0.00072074 -0.0198074 -0.000659016 -0.00641186 0.0197662 0.00641637 0.0 +542 2.65 3.55 101.25 0.00112223 0.00094823 -0.0011259 -0.00217623 -0.000927796 0.00217226 0.0 +543 2.65 3.55 108.75 0.00303859 0.0169456 -0.0030474 0.000636489 -0.0170012 -0.000616911 0.0 +544 2.65 3.55 116.25 0.00293939 0.0254903 -0.00299498 0.00226534 -0.0254881 -0.00227427 0.0 +545 2.65 3.55 123.75 0.00105767 0.0250956 -0.00100249 0.00302411 -0.0251043 -0.00302286 0.0 +546 2.65 3.55 131.25 0.00089622 0.018822 -0.000861732 0.00254531 -0.0188028 -0.00256904 0.0 +547 2.65 3.55 138.75 0.00382565 0.0100627 -0.0038702 0.000936262 -0.0101195 -0.000921113 0.0 +548 2.65 3.55 146.25 0.00637878 -0.00112474 -0.0063611 -0.000499545 0.00116119 0.000462636 0.0 +549 2.65 3.55 153.75 0.00342379 -0.0163538 -0.00340327 -0.0001089 0.0163686 9.31942e-05 0.0 +550 2.65 3.55 161.25 -0.0063525 -0.0350349 0.00642576 0.00261085 0.0350954 -0.00266173 0.0 +551 2.65 3.55 168.75 -0.0193118 -0.0529521 0.01932 0.00641632 0.0530167 -0.00647477 0.0 +552 2.65 3.55 176.25 -0.0282729 -0.0640227 0.0283342 0.00913184 0.0640796 -0.00915341 0.0 +553 2.65 3.65 3.75 -9.07399 3.23181 9.07399 31.5979 -3.23181 -31.5979 0.0 +554 2.65 3.65 11.25 -6.54957 2.36668 6.54957 18.1922 -2.36668 -18.1922 0.0 +555 2.65 3.65 18.75 -3.41782 1.35636 3.41782 6.44075 -1.35636 -6.44075 0.0 +556 2.65 3.65 26.25 -1.25794 0.63761 1.25794 1.4388 -0.63761 -1.4388 0.0 +557 2.65 3.65 33.75 -0.314954 0.229217 0.314955 0.252105 -0.229219 -0.252103 0.0 +558 2.65 3.65 41.25 -0.0703285 0.0433984 0.0703295 0.0804037 -0.0433987 -0.080406 0.0 +559 2.65 3.65 48.75 -0.0346923 -0.00594178 0.0346905 0.0178914 0.00594136 -0.0178931 0.0 +560 2.65 3.65 56.25 -0.0178793 -0.00218658 0.0178826 -0.0109585 0.00218474 0.0109613 0.0 +561 2.65 3.65 63.75 -0.00296649 0.00371443 0.00296685 -0.0077863 -0.00371456 0.00778602 0.0 +562 2.65 3.65 71.25 0.00156936 0.00391538 -0.00157049 -0.000554586 -0.00391343 0.000556069 0.0 +563 2.65 3.65 78.75 4.72839e-05 0.00437901 -5.76159e-05 0.000766606 -0.00437852 -0.000767667 0.0 +564 2.65 3.65 86.25 -0.00150151 0.00465743 0.00150145 4.48359e-05 -0.00465746 -4.47759e-05 0.0 +565 2.65 3.65 93.75 -0.00154911 0.0023728 0.00155712 3.94444e-05 -0.00237267 -3.93568e-05 0.0 +566 2.65 3.65 101.25 -0.00102647 -0.00107232 0.0010322 0.000455843 0.00107411 -0.000456348 0.0 +567 2.65 3.65 108.75 -0.000931385 -0.00331098 0.000926423 0.000617065 0.00331642 -0.000619741 0.0 +568 2.65 3.65 116.25 -0.00125989 -0.00405896 0.00125662 0.000489735 0.00405917 -0.000489051 0.0 +569 2.65 3.65 123.75 -0.00119027 -0.00416793 0.00118127 0.00025776 0.00417216 -0.000258364 0.0 +570 2.65 3.65 131.25 2.02558e-06 -0.00385544 9.97877e-07 -5.65576e-05 0.00385538 5.6561e-05 0.0 +571 2.65 3.65 138.75 0.0019471 -0.0027434 -0.00193851 -0.000439961 0.00274576 0.000440451 0.0 +572 2.65 3.65 146.25 0.00340728 -0.000754999 -0.00340313 -0.000680537 0.000762165 0.000677165 0.0 +573 2.65 3.65 153.75 0.00324508 0.00162334 -0.00324525 -0.000497576 -0.00162245 0.000496814 0.0 +574 2.65 3.65 161.25 0.00132741 0.00369896 -0.00132849 0.000164919 -0.00371082 -0.000158918 0.0 +575 2.65 3.65 168.75 -0.00130947 0.00507786 0.00131187 0.00102227 -0.00507988 -0.00102051 0.0 +576 2.65 3.65 176.25 -0.00317672 0.00571563 0.00316942 0.00161776 -0.00571614 -0.00161842 0.0 +577 2.75 2.55 3.75 -646.883 -824.761 646.883 13661.4 824.761 -13661.4 0.0 +578 2.75 2.55 11.25 -376.729 -565.131 376.729 4500.92 565.131 -4500.92 0.0 +579 2.75 2.55 18.75 -160.492 -319.439 160.492 1493.04 319.439 -1493.04 0.0 +580 2.75 2.55 26.25 -43.8362 -150.439 43.8362 427.402 150.439 -427.402 0.0 +581 2.75 2.55 33.75 -1.31067 -57.798 1.31064 92.2844 57.798 -92.2844 0.0 +582 2.75 2.55 41.25 6.00479 -16.8893 -6.00479 12.5367 16.8893 -12.5367 0.0 +583 2.75 2.55 48.75 4.03968 -2.60255 -4.0397 0.399313 2.60257 -0.399325 0.0 +584 2.75 2.55 56.25 2.21549 0.863126 -2.21544 -0.669249 -0.863129 0.669252 0.0 +585 2.75 2.55 63.75 1.40852 0.965831 -1.40854 -0.799145 -0.965837 0.799139 0.0 +586 2.75 2.55 71.25 0.877522 0.581863 -0.877718 -0.688179 -0.58189 0.688182 0.0 +587 2.75 2.55 78.75 0.432572 0.486926 -0.432514 -0.598602 -0.486947 0.598584 0.0 +588 2.75 2.55 86.25 0.163082 0.5836 -0.163134 -0.629205 -0.583719 0.629203 0.0 +589 2.75 2.55 93.75 0.0579151 0.606926 -0.0578918 -0.622595 -0.606869 0.622589 0.0 +590 2.75 2.55 101.25 0.0188255 0.45842 -0.0190481 -0.481734 -0.458384 0.481734 0.0 +591 2.75 2.55 108.75 -0.0159447 0.212618 0.0158542 -0.267236 -0.212519 0.267236 0.0 +592 2.75 2.55 116.25 -0.0341603 -0.00942321 0.0342676 -0.0831169 0.00944397 0.0831394 0.0 +593 2.75 2.55 123.75 0.00214989 -0.134649 -0.00214598 0.0210578 0.134553 -0.0210391 0.0 +594 2.75 2.55 131.25 0.0938516 -0.166277 -0.0938361 0.0622856 0.166334 -0.0623105 0.0 +595 2.75 2.55 138.75 0.18366 -0.166533 -0.183695 0.0899007 0.166491 -0.0898952 0.0 +596 2.75 2.55 146.25 0.192167 -0.212871 -0.19235 0.147586 0.212929 -0.147608 0.0 +597 2.75 2.55 153.75 0.0741489 -0.350932 -0.0741025 0.250625 0.350927 -0.250612 0.0 +598 2.75 2.55 161.25 -0.14589 -0.565391 0.145774 0.382212 0.565381 -0.382217 0.0 +599 2.75 2.55 168.75 -0.383057 -0.786435 0.383012 0.504804 0.786416 -0.504808 0.0 +600 2.75 2.55 176.25 -0.535417 -0.926475 0.535265 0.578566 0.926571 -0.578605 0.0 +601 2.75 2.65 3.75 -831.831 -860.5 831.831 20895.9 860.5 -20895.9 0.0 +602 2.75 2.65 11.25 -475.094 -547.496 475.094 5365.4 547.496 -5365.4 0.0 +603 2.75 2.65 18.75 -211.099 -284.158 211.099 1707.48 284.158 -1707.48 0.0 +604 2.75 2.65 26.25 -68.5394 -118.424 68.5394 479.405 118.424 -479.405 0.0 +605 2.75 2.65 33.75 -13.6757 -38.7319 13.6757 102.918 38.7319 -102.918 0.0 +606 2.75 2.65 41.25 -0.641629 -9.94534 0.641516 15.2464 9.94536 -15.2464 0.0 +607 2.75 2.65 48.75 0.332944 -2.18488 -0.332922 1.85409 2.18487 -1.8541 0.0 +608 2.75 2.65 56.25 0.112165 -0.465651 -0.112096 0.181132 0.46563 -0.181143 0.0 +609 2.75 2.65 63.75 0.17644 -0.0725113 -0.176231 -0.386031 0.0725132 0.386039 0.0 +610 2.75 2.65 71.25 0.181446 0.0079536 -0.181422 -0.450971 -0.0079448 0.450977 0.0 +611 2.75 2.65 78.75 0.1272 0.0562691 -0.126984 -0.35027 -0.0562978 0.350258 0.0 +612 2.75 2.65 86.25 0.131164 0.146678 -0.130971 -0.320782 -0.146689 0.320782 0.0 +613 2.75 2.65 93.75 0.184111 0.220732 -0.184056 -0.310724 -0.220653 0.310723 0.0 +614 2.75 2.65 101.25 0.213605 0.217192 -0.213601 -0.244091 -0.217167 0.244081 0.0 +615 2.75 2.65 108.75 0.179639 0.136558 -0.179737 -0.132731 -0.136657 0.132727 0.0 +616 2.75 2.65 116.25 0.100081 0.0217289 -0.100093 -0.0251836 -0.0217251 0.0251759 0.0 +617 2.75 2.65 123.75 0.0195628 -0.0815694 -0.0193724 0.0480742 0.0816744 -0.0480962 0.0 +618 2.75 2.65 131.25 -0.0392766 -0.157775 0.0391865 0.0897435 0.157642 -0.0896697 0.0 +619 2.75 2.65 138.75 -0.100375 -0.232729 0.100477 0.125775 0.232723 -0.125727 0.0 +620 2.75 2.65 146.25 -0.214623 -0.354582 0.214959 0.184674 0.354626 -0.184677 0.0 +621 2.75 2.65 153.75 -0.413318 -0.55297 0.413289 0.278244 0.552966 -0.278243 0.0 +622 2.75 2.65 161.25 -0.673058 -0.807985 0.672735 0.393846 0.807876 -0.393806 0.0 +623 2.75 2.65 168.75 -0.921828 -1.05215 0.921789 0.500727 1.05224 -0.500783 0.0 +624 2.75 2.65 176.25 -1.07494 -1.20227 1.0747 0.564979 1.20218 -0.564915 0.0 +625 2.75 2.75 3.75 -953.112 -854.306 953.112 25981 854.306 -25981 0.0 +626 2.75 2.75 11.25 -539.051 -520.941 539.051 5855.95 520.941 -5855.95 0.0 +627 2.75 2.75 18.75 -242.983 -254.204 242.983 1824.66 254.204 -1824.66 0.0 +628 2.75 2.75 26.25 -83.2573 -94.4794 83.2573 502.272 94.4793 -502.272 0.0 +629 2.75 2.75 33.75 -20.5412 -24.7823 20.5412 104.828 24.7823 -104.828 0.0 +630 2.75 2.75 41.25 -3.9136 -4.29412 3.91362 14.9464 4.2941 -14.9465 0.0 +631 2.75 2.75 48.75 -1.12328 -0.873619 1.12322 1.93019 0.873624 -1.93018 0.0 +632 2.75 2.75 56.25 -0.514324 -0.496154 0.514312 0.391368 0.496221 -0.39134 0.0 +633 2.75 2.75 63.75 -0.164596 -0.213443 0.164691 -0.208447 0.213484 0.208481 0.0 +634 2.75 2.75 71.25 -0.041967 -0.0485499 0.0420123 -0.328452 0.0485135 0.328445 0.0 +635 2.75 2.75 78.75 0.00770861 0.0144404 -0.0076428 -0.256255 -0.0144125 0.25625 0.0 +636 2.75 2.75 86.25 0.090797 0.0907928 -0.090835 -0.225168 -0.0907865 0.225168 0.0 +637 2.75 2.75 93.75 0.181978 0.179759 -0.182045 -0.218388 -0.179673 0.218388 0.0 +638 2.75 2.75 101.25 0.225859 0.223811 -0.2259 -0.17996 -0.22375 0.17996 0.0 +639 2.75 2.75 108.75 0.197221 0.193022 -0.197213 -0.105534 -0.19316 0.105561 0.0 +640 2.75 2.75 116.25 0.109362 0.103419 -0.109316 -0.0211263 -0.10351 0.0211473 0.0 +641 2.75 2.75 123.75 0.00356169 -0.00337669 -0.00365545 0.0468134 0.00343037 -0.0468135 0.0 +642 2.75 2.75 131.25 -0.0899181 -0.097849 0.0896843 0.0904862 0.0978568 -0.090473 0.0 +643 2.75 2.75 138.75 -0.180752 -0.189165 0.180483 0.124806 0.189251 -0.124873 0.0 +644 2.75 2.75 146.25 -0.307245 -0.315227 0.307006 0.173842 0.315177 -0.173832 0.0 +645 2.75 2.75 153.75 -0.495888 -0.504071 0.495883 0.250885 0.504047 -0.250882 0.0 +646 2.75 2.75 161.25 -0.730452 -0.740638 0.730449 0.347741 0.740677 -0.347784 0.0 +647 2.75 2.75 168.75 -0.951281 -0.965256 0.9512 0.438629 0.965085 -0.438584 0.0 +648 2.75 2.75 176.25 -1.08583 -1.10279 1.08592 0.493743 1.10285 -0.493793 0.0 +649 2.75 2.85 3.75 -970.563 -775.744 970.563 23153.2 775.744 -23153.2 0.0 +650 2.75 2.85 11.25 -556.721 -474.097 556.721 5862.74 474.097 -5862.74 0.0 +651 2.75 2.85 18.75 -250.751 -224.584 250.751 1827.2 224.584 -1827.2 0.0 +652 2.75 2.85 26.25 -86.059 -77.5526 86.059 494.052 77.5526 -494.052 0.0 +653 2.75 2.85 33.75 -21.7848 -16.8577 21.7848 99.2767 16.8577 -99.2767 0.0 +654 2.75 2.85 41.25 -4.50961 -1.52272 4.5095 12.9376 1.52274 -12.9376 0.0 +655 2.75 2.85 48.75 -1.25065 -0.243785 1.25071 1.39261 0.243763 -1.39263 0.0 +656 2.75 2.85 56.25 -0.463066 -0.460087 0.463015 0.300113 0.460075 -0.300136 0.0 +657 2.75 2.85 63.75 -0.151187 -0.275288 0.151132 -0.144808 0.275348 0.144857 0.0 +658 2.75 2.85 71.25 -0.0749749 -0.110892 0.0749169 -0.249281 0.110829 0.249264 0.0 +659 2.75 2.85 78.75 -0.0201116 -0.0351113 0.0202283 -0.210984 0.0351362 0.210976 0.0 +660 2.75 2.85 86.25 0.0736389 0.0501401 -0.0736054 -0.194737 -0.0502144 0.194733 0.0 +661 2.75 2.85 93.75 0.160078 0.146192 -0.159898 -0.1879 -0.146241 0.187904 0.0 +662 2.75 2.85 101.25 0.200786 0.204303 -0.200728 -0.156391 -0.204259 0.156374 0.0 +663 2.75 2.85 108.75 0.17997 0.193028 -0.179585 -0.0955768 -0.192919 0.0955569 0.0 +664 2.75 2.85 116.25 0.103624 0.119278 -0.103941 -0.0221991 -0.119219 0.0221951 0.0 +665 2.75 2.85 123.75 0.00644177 0.0211333 -0.00659697 0.0394802 -0.0210367 -0.0394978 0.0 +666 2.75 2.85 131.25 -0.0803186 -0.0672129 0.080414 0.0781492 0.0671178 -0.0781413 0.0 +667 2.75 2.85 138.75 -0.161637 -0.148838 0.161505 0.105436 0.149111 -0.105534 0.0 +668 2.75 2.85 146.25 -0.270086 -0.257695 0.270083 0.14428 0.257823 -0.144344 0.0 +669 2.75 2.85 153.75 -0.43239 -0.421507 0.432363 0.208547 0.421587 -0.208591 0.0 +670 2.75 2.85 161.25 -0.634898 -0.628455 0.634872 0.291785 0.628448 -0.291789 0.0 +671 2.75 2.85 168.75 -0.826247 -0.825693 0.826352 0.370982 0.825733 -0.37098 0.0 +672 2.75 2.85 176.25 -0.943351 -0.946865 0.943117 0.419282 0.946914 -0.419356 0.0 +673 2.75 2.95 3.75 -897.538 -636.356 897.538 17274.5 636.356 -17274.5 0.0 +674 2.75 2.95 11.25 -527.594 -400.007 527.594 5426.93 400.007 -5426.93 0.0 +675 2.75 2.95 18.75 -234.856 -188.606 234.856 1719.6 188.606 -1719.6 0.0 +676 2.75 2.95 26.25 -78.0109 -63.1924 78.0109 457.632 63.1924 -457.632 0.0 +677 2.75 2.95 33.75 -18.5523 -12.6415 18.5523 88.2261 12.6415 -88.2261 0.0 +678 2.75 2.95 41.25 -3.43241 -0.788747 3.43237 10.3311 0.788758 -10.3311 0.0 +679 2.75 2.95 48.75 -0.834456 -0.199558 0.834517 0.799118 0.199613 -0.799125 0.0 +680 2.75 2.95 56.25 -0.273778 -0.463123 0.273749 0.148104 0.463143 -0.148167 0.0 +681 2.75 2.95 63.75 -0.103413 -0.318818 0.103504 -0.111608 0.31885 0.111645 0.0 +682 2.75 2.95 71.25 -0.0843263 -0.181793 0.0843793 -0.175312 0.181809 0.175287 0.0 +683 2.75 2.95 78.75 -0.0303993 -0.093494 0.0304044 -0.167209 0.0935528 0.167232 0.0 +684 2.75 2.95 86.25 0.0620423 0.00699782 -0.0622995 -0.169543 -0.00683051 0.169553 0.0 +685 2.75 2.95 93.75 0.136614 0.106217 -0.136678 -0.163514 -0.106191 0.163506 0.0 +686 2.75 2.95 101.25 0.17196 0.170249 -0.171903 -0.134812 -0.170364 0.13483 0.0 +687 2.75 2.95 108.75 0.15684 0.174342 -0.156924 -0.0828548 -0.174193 0.082802 0.0 +688 2.75 2.95 116.25 0.0926482 0.118695 -0.0927901 -0.0195911 -0.118646 0.0195826 0.0 +689 2.75 2.95 123.75 0.00849675 0.0355959 -0.00833828 0.0336514 -0.0356652 -0.0336479 0.0 +690 2.75 2.95 131.25 -0.0660839 -0.0418908 0.0662238 0.0659291 0.041797 -0.065883 0.0 +691 2.75 2.95 138.75 -0.134275 -0.114174 0.134106 0.0880437 0.114322 -0.0880806 0.0 +692 2.75 2.95 146.25 -0.227305 -0.21177 0.227027 0.121094 0.2116 -0.121002 0.0 +693 2.75 2.95 153.75 -0.368554 -0.358527 0.368374 0.177219 0.358663 -0.177335 0.0 +694 2.75 2.95 161.25 -0.546482 -0.542986 0.546711 0.250148 0.542877 -0.250051 0.0 +695 2.75 2.95 168.75 -0.715439 -0.717898 0.715379 0.319323 0.717937 -0.319304 0.0 +696 2.75 2.95 176.25 -0.817997 -0.824689 0.818295 0.361371 0.825027 -0.361574 0.0 +697 2.75 3.05 3.75 -770.161 -463.434 770.161 12393.7 463.434 -12393.7 0.0 +698 2.75 3.05 11.25 -462.237 -301.474 462.237 4693.99 301.474 -4693.99 0.0 +699 2.75 3.05 18.75 -201.495 -143.479 201.495 1525.17 143.479 -1525.17 0.0 +700 2.75 3.05 26.25 -62.9238 -47.8688 62.9238 399.794 47.8688 -399.794 0.0 +701 2.75 3.05 33.75 -12.9682 -9.61891 12.9682 73.8547 9.61892 -73.8547 0.0 +702 2.75 3.05 41.25 -1.7583 -0.85457 1.75829 7.81837 0.854518 -7.81834 0.0 +703 2.75 3.05 48.75 -0.381642 -0.346117 0.381587 0.40516 0.34605 -0.405176 0.0 +704 2.75 3.05 56.25 -0.163641 -0.440252 0.163583 0.0381865 0.440156 -0.0381959 0.0 +705 2.75 3.05 63.75 -0.103568 -0.332346 0.103485 -0.0833787 0.332372 0.0833554 0.0 +706 2.75 3.05 71.25 -0.101444 -0.24461 0.101602 -0.107568 0.244525 0.107546 0.0 +707 2.75 3.05 78.75 -0.038508 -0.1504 0.038783 -0.1224 0.150253 0.122395 0.0 +708 2.75 3.05 86.25 0.0496984 -0.0343332 -0.0494439 -0.140095 0.0345932 0.140101 0.0 +709 2.75 3.05 93.75 0.111297 0.06995 -0.111612 -0.135869 -0.0701637 0.135882 0.0 +710 2.75 3.05 101.25 0.140426 0.140943 -0.140275 -0.110396 -0.140778 0.110407 0.0 +711 2.75 3.05 108.75 0.12795 0.158778 -0.128322 -0.0664922 -0.158818 0.0664985 0.0 +712 2.75 3.05 116.25 0.0728381 0.119891 -0.0730793 -0.0130873 -0.11982 0.0129934 0.0 +713 2.75 3.05 123.75 0.000267345 0.0511317 -9.01598e-05 0.0314953 -0.0510922 -0.03149 0.0 +714 2.75 3.05 131.25 -0.063069 -0.0174406 0.0628665 0.0580034 0.0170276 -0.0579042 0.0 +715 2.75 3.05 138.75 -0.119018 -0.0842153 0.11903 0.0763319 0.0841315 -0.0762935 0.0 +716 2.75 3.05 146.25 -0.197865 -0.1752 0.197467 0.104414 0.175196 -0.104295 0.0 +717 2.75 3.05 153.75 -0.319615 -0.309756 0.319424 0.151665 0.309809 -0.15167 0.0 +718 2.75 3.05 161.25 -0.473103 -0.474577 0.47295 0.212121 0.474601 -0.212138 0.0 +719 2.75 3.05 168.75 -0.617392 -0.628077 0.617611 0.268756 0.627819 -0.268631 0.0 +720 2.75 3.05 176.25 -0.705354 -0.720636 0.705297 0.302934 0.720794 -0.303013 0.0 +721 2.75 3.15 3.75 -621.059 -283.307 621.059 8818.58 283.307 -8818.58 0.0 +722 2.75 3.15 11.25 -378.076 -190.869 378.076 3830.09 190.869 -3830.09 0.0 +723 2.75 3.15 18.75 -160.427 -92.3481 160.427 1277.7 92.3481 -1277.7 0.0 +724 2.75 3.15 26.25 -45.9966 -30.9532 45.9966 329.373 30.9532 -329.373 0.0 +725 2.75 3.15 33.75 -7.4094 -6.49374 7.40945 58.1344 6.49371 -58.1344 0.0 +726 2.75 3.15 41.25 -0.360268 -0.948504 0.360207 5.64912 0.948525 -5.64911 0.0 +727 2.75 3.15 48.75 -0.109681 -0.454359 0.109583 0.215632 0.454311 -0.215651 0.0 +728 2.75 3.15 56.25 -0.128581 -0.381055 0.12849 -0.024614 0.380998 0.0245607 0.0 +729 2.75 3.15 63.75 -0.107772 -0.325095 0.107852 -0.0656164 0.325178 0.0656213 0.0 +730 2.75 3.15 71.25 -0.10009 -0.293719 0.100061 -0.059479 0.293753 0.059475 0.0 +731 2.75 3.15 78.75 -0.036158 -0.200438 0.0358502 -0.0856231 0.200546 0.0856524 0.0 +732 2.75 3.15 86.25 0.0377439 -0.0742392 -0.037571 -0.109183 0.0742289 0.109172 0.0 +733 2.75 3.15 93.75 0.0838315 0.0343987 -0.0838656 -0.104987 -0.0344864 0.105012 0.0 +734 2.75 3.15 101.25 0.106057 0.110494 -0.106108 -0.0834801 -0.110598 0.0834927 0.0 +735 2.75 3.15 108.75 0.0968552 0.139813 -0.0967877 -0.0483794 -0.139765 0.0483448 0.0 +736 2.75 3.15 116.25 0.051391 0.115917 -0.0515763 -0.0060004 -0.116112 0.00610288 0.0 +737 2.75 3.15 123.75 -0.00713598 0.0613642 0.00718246 0.0286098 -0.0614779 -0.0285439 0.0 +738 2.75 3.15 131.25 -0.0559847 0.00396885 0.0560961 0.0483465 -0.00390007 -0.0484359 0.0 +739 2.75 3.15 138.75 -0.0990609 -0.0545791 0.0984659 0.061732 0.0548182 -0.0618343 0.0 +740 2.75 3.15 146.25 -0.159454 -0.134936 0.1595 0.0827794 0.135061 -0.08272 0.0 +741 2.75 3.15 153.75 -0.25524 -0.251075 0.255086 0.118141 0.251122 -0.118172 0.0 +742 2.75 3.15 161.25 -0.375288 -0.38964 0.375663 0.162894 0.389747 -0.16293 0.0 +743 2.75 3.15 168.75 -0.488486 -0.516392 0.488643 0.204424 0.516148 -0.204273 0.0 +744 2.75 3.15 176.25 -0.556839 -0.591689 0.556911 0.229329 0.591767 -0.229304 0.0 +745 2.75 3.25 3.75 -476.667 -121.19 476.667 6210.58 121.19 -6210.58 0.0 +746 2.75 3.25 11.25 -293.373 -85.8334 293.373 2968.1 85.8334 -2968.1 0.0 +747 2.75 3.25 18.75 -121.508 -42.7495 121.508 1012.27 42.7495 -1012.27 0.0 +748 2.75 3.25 26.25 -31.8786 -14.325 31.8786 255.334 14.325 -255.334 0.0 +749 2.75 3.25 33.75 -3.63288 -3.16546 3.63301 42.6516 3.16544 -42.6516 0.0 +750 2.75 3.25 41.25 0.315726 -0.793557 -0.315791 3.80727 0.79365 -3.8073 0.0 +751 2.75 3.25 48.75 -0.0242544 -0.460584 0.0242178 0.130581 0.460619 -0.130536 0.0 +752 2.75 3.25 56.25 -0.0991531 -0.30838 0.0992679 -0.0606306 0.308269 0.0605918 0.0 +753 2.75 3.25 63.75 -0.0775749 -0.303078 0.0775341 -0.058713 0.303134 0.0587059 0.0 +754 2.75 3.25 71.25 -0.0726081 -0.316404 0.0725509 -0.0320203 0.316355 0.0321083 0.0 +755 2.75 3.25 78.75 -0.0250871 -0.232854 0.0249036 -0.0576022 0.232759 0.0576201 0.0 +756 2.75 3.25 86.25 0.0262879 -0.108161 -0.0264355 -0.0771184 0.108011 0.0771155 0.0 +757 2.75 3.25 93.75 0.0560476 -0.000207024 -0.0559883 -0.0716051 0.000146475 0.0716155 0.0 +758 2.75 3.25 101.25 0.072468 0.0806321 -0.0723149 -0.0559611 -0.0805163 0.0559016 0.0 +759 2.75 3.25 108.75 0.0683282 0.121003 -0.068317 -0.0319853 -0.121 0.0319423 0.0 +760 2.75 3.25 116.25 0.0376756 0.112607 -0.037291 -0.00283035 -0.112703 0.00284452 0.0 +761 2.75 3.25 123.75 -0.00470402 0.0730337 0.00443815 0.0205484 -0.072994 -0.0206443 0.0 +762 2.75 3.25 131.25 -0.0393657 0.0275953 0.0393646 0.0333389 -0.02763 -0.0332308 0.0 +763 2.75 3.25 138.75 -0.0690594 -0.0208708 0.0692442 0.0419952 0.0207699 -0.0419967 0.0 +764 2.75 3.25 146.25 -0.111014 -0.0862657 0.110952 0.0560987 0.0863438 -0.0561322 0.0 +765 2.75 3.25 153.75 -0.176809 -0.178443 0.176496 0.0798216 0.178512 -0.0798746 0.0 +766 2.75 3.25 161.25 -0.258767 -0.286055 0.259122 0.109635 0.286421 -0.109773 0.0 +767 2.75 3.25 168.75 -0.336709 -0.383242 0.3365 0.137155 0.383371 -0.137249 0.0 +768 2.75 3.25 176.25 -0.383233 -0.440518 0.383304 0.153612 0.440294 -0.153402 0.0 +769 2.75 3.35 3.75 -341.385 1.74756 341.385 4134.74 -1.74757 -4134.74 0.0 +770 2.75 3.35 11.25 -213.168 -3.19693 213.168 2109.24 3.19691 -2109.24 0.0 +771 2.75 3.35 18.75 -87.8275 -2.99417 87.8276 729.622 2.99416 -729.622 0.0 +772 2.75 3.35 26.25 -22.0888 -0.704944 22.0887 178.369 0.70499 -178.369 0.0 +773 2.75 3.35 33.75 -2.07542 -0.0682655 2.0755 27.6089 0.0682662 -27.6089 0.0 +774 2.75 3.35 41.25 0.300247 -0.350456 -0.300305 2.18926 0.350473 -2.18927 0.0 +775 2.75 3.35 48.75 -0.0373785 -0.369541 0.0374118 0.0833796 0.36958 -0.083402 0.0 +776 2.75 3.35 56.25 -0.0518069 -0.259322 0.0517312 -0.0686295 0.259412 0.0687251 0.0 +777 2.75 3.35 63.75 -0.0322367 -0.285586 0.0323754 -0.0471277 0.285461 0.0471608 0.0 +778 2.75 3.35 71.25 -0.0437375 -0.317171 0.043788 -0.0133265 0.317084 0.0133532 0.0 +779 2.75 3.35 78.75 -0.0172441 -0.248737 0.0171536 -0.0330689 0.248747 0.0330618 0.0 +780 2.75 3.35 86.25 0.0144849 -0.135178 -0.014571 -0.0452186 0.135353 0.0452189 0.0 +781 2.75 3.35 93.75 0.030471 -0.0300865 -0.030347 -0.0398041 0.0300945 0.0397911 0.0 +782 2.75 3.35 101.25 0.0406014 0.0563913 -0.0407253 -0.0312837 -0.0564639 0.0312859 0.0 +783 2.75 3.35 108.75 0.0422766 0.108893 -0.0423538 -0.0189637 -0.109138 0.0190212 0.0 +784 2.75 3.35 116.25 0.0267588 0.115186 -0.0269597 -0.00297617 -0.11525 0.00295127 0.0 +785 2.75 3.35 123.75 0.000501099 0.0878862 -0.000774694 0.0104498 -0.0881349 -0.0102325 0.0 +786 2.75 3.35 131.25 -0.0236225 0.0489236 0.0238085 0.0185255 -0.0490552 -0.0184822 0.0 +787 2.75 3.35 138.75 -0.0444452 0.00629968 0.044223 0.0246731 -0.00652667 -0.0245664 0.0 +788 2.75 3.35 146.25 -0.0693381 -0.0474412 0.069485 0.0339103 0.0474594 -0.0339419 0.0 +789 2.75 3.35 153.75 -0.107186 -0.118947 0.107138 0.0484857 0.1189 -0.0484203 0.0 +790 2.75 3.35 161.25 -0.154793 -0.200912 0.154723 0.0665572 0.200588 -0.0663788 0.0 +791 2.75 3.35 168.75 -0.200583 -0.274251 0.200264 0.0833152 0.274149 -0.0833102 0.0 +792 2.75 3.35 176.25 -0.22795 -0.317539 0.228214 0.0934114 0.317615 -0.093522 0.0 +793 2.75 3.45 3.75 -181.602 50.4515 181.602 2007.55 -50.4515 -2007.55 0.0 +794 2.75 3.45 11.25 -116.135 31.353 116.135 1069.23 -31.3531 -1069.23 0.0 +795 2.75 3.45 18.75 -49.1544 14.1197 49.1544 371.433 -14.1197 -371.433 0.0 +796 2.75 3.45 26.25 -12.9027 5.27843 12.9027 86.871 -5.27842 -86.871 0.0 +797 2.75 3.45 33.75 -1.53044 1.58922 1.53042 12.1098 -1.58919 -12.1098 0.0 +798 2.75 3.45 41.25 0.0034182 0.175305 -0.00341175 0.852259 -0.175314 -0.852262 0.0 +799 2.75 3.45 48.75 -0.0627082 -0.187051 0.0626463 0.0745378 0.187162 -0.0745079 0.0 +800 2.75 3.45 56.25 -0.0269175 -0.208615 0.0269865 -0.0380544 0.208565 0.0380413 0.0 +801 2.75 3.45 63.75 -0.0156683 -0.232533 0.0156754 -0.0230666 0.232476 0.0230535 0.0 +802 2.75 3.45 71.25 -0.027083 -0.247837 0.027041 5.30776e-05 0.247723 -0.000124963 0.0 +803 2.75 3.45 78.75 -0.0110419 -0.199747 0.0110237 -0.01275 0.199733 0.0127249 0.0 +804 2.75 3.45 86.25 0.00600723 -0.118375 -0.00584057 -0.01943 0.118327 0.0194294 0.0 +805 2.75 3.45 93.75 0.00873478 -0.0394094 -0.00879205 -0.0152652 0.0394659 0.0152585 0.0 +806 2.75 3.45 101.25 0.00962037 0.0272073 -0.00960224 -0.0103152 -0.0271381 0.0103031 0.0 +807 2.75 3.45 108.75 0.0122306 0.0719369 -0.0122886 -0.00545491 -0.071926 0.00547195 0.0 +808 2.75 3.45 116.25 0.00974245 0.0846866 -0.00979763 -2.00295e-05 -0.084746 5.2625e-05 0.0 +809 2.75 3.45 123.75 0.000243929 0.070346 -0.000352399 0.00484904 -0.0702929 -0.00489636 0.0 +810 2.75 3.45 131.25 -0.010453 0.043801 0.0102586 0.00831848 -0.0439736 -0.00824598 0.0 +811 2.75 3.45 138.75 -0.0180464 0.0137037 0.0179837 0.0107806 -0.0137201 -0.0108167 0.0 +812 2.75 3.45 146.25 -0.025475 -0.0218772 0.0256088 0.0136926 0.0220646 -0.0138449 0.0 +813 2.75 3.45 153.75 -0.0382383 -0.0672046 0.0382092 0.0186021 0.0672579 -0.018626 0.0 +814 2.75 3.45 161.25 -0.0575259 -0.119353 0.0574959 0.0256839 0.119252 -0.0256513 0.0 +815 2.75 3.45 168.75 -0.0781428 -0.166869 0.078149 0.0330717 0.16689 -0.0331148 0.0 +816 2.75 3.45 176.25 -0.0916728 -0.195518 0.0917779 0.0378401 0.195665 -0.037981 0.0 +817 2.75 3.55 3.75 -60.5153 27.692 60.5153 588.046 -27.692 -588.046 0.0 +818 2.75 3.55 11.25 -39.8784 17.4201 39.8784 321.892 -17.4201 -321.892 0.0 +819 2.75 3.55 18.75 -17.6334 7.7718 17.6334 111.365 -7.7718 -111.365 0.0 +820 2.75 3.55 26.25 -4.94614 2.91047 4.94616 24.801 -2.91047 -24.801 0.0 +821 2.75 3.55 33.75 -0.717862 1.02613 0.717872 3.21211 -1.02616 -3.21209 0.0 +822 2.75 3.55 41.25 -0.0703286 0.253386 0.0703577 0.326292 -0.253389 -0.326305 0.0 +823 2.75 3.55 48.75 -0.0696314 -0.0360868 0.0696098 0.0745468 0.0361057 -0.0745544 0.0 +824 2.75 3.55 56.25 -0.0386849 -0.0894109 0.0386635 -0.0191097 0.0894516 0.0190794 0.0 +825 2.75 3.55 63.75 -0.0158765 -0.0925221 0.0158458 -0.0145167 0.09256 0.0145237 0.0 +826 2.75 3.55 71.25 -0.00997075 -0.0929607 0.00998059 0.000467248 0.0929809 -0.000443377 0.0 +827 2.75 3.55 78.75 -0.00149974 -0.0734939 0.00146198 -0.00355586 0.0735358 0.00355353 0.0 +828 2.75 3.55 86.25 0.0028805 -0.042718 -0.00289025 -0.00634796 0.0427423 0.00634686 0.0 +829 2.75 3.55 93.75 -0.000895397 -0.0173398 0.000915914 -0.00268197 0.0173692 0.00268557 0.0 +830 2.75 3.55 101.25 -0.00461455 0.00200332 0.00464936 0.00177679 -0.00195006 -0.0017874 0.0 +831 2.75 3.55 108.75 -0.00367123 0.0176377 0.00372332 0.00363241 -0.0176972 -0.00361264 0.0 +832 2.75 3.55 116.25 -0.00131124 0.0260317 0.00133193 0.00346321 -0.0260021 -0.00346733 0.0 +833 2.75 3.55 123.75 -0.000257145 0.0251737 0.000204938 0.00292588 -0.0251838 -0.00291469 0.0 +834 2.75 3.55 131.25 0.000973531 0.0188626 -0.000971992 0.00228745 -0.0188196 -0.00232812 0.0 +835 2.75 3.55 138.75 0.00409367 0.011615 -0.00404917 0.000911448 -0.011591 -0.000925473 0.0 +836 2.75 3.55 146.25 0.00744491 0.00348645 -0.0075166 -0.000905243 -0.00344952 0.000869305 0.0 +837 2.75 3.55 153.75 0.00762023 -0.00783196 -0.00763712 -0.00180907 0.00784858 0.00180265 0.0 +838 2.75 3.55 161.25 0.00271034 -0.0229315 -0.00264761 -0.000890015 0.0229401 0.000888095 0.0 +839 2.75 3.55 168.75 -0.0051415 -0.0382675 0.00514139 0.00125874 0.0383533 -0.00131918 0.0 +840 2.75 3.55 176.25 -0.0109249 -0.0480268 0.0109626 0.00300256 0.0480665 -0.00301775 0.0 +841 2.75 3.65 3.75 -5.4585 2.19054 5.4585 46.1523 -2.19054 -46.1523 0.0 +842 2.75 3.65 11.25 -3.66097 1.22096 3.66097 25.7483 -1.22096 -25.7483 0.0 +843 2.75 3.65 18.75 -1.63156 0.409151 1.63156 8.91799 -0.409152 -8.91799 0.0 +844 2.75 3.65 26.25 -0.435259 0.123143 0.435261 1.99397 -0.123144 -1.99397 0.0 +845 2.75 3.65 33.75 -0.0493642 0.0652704 0.0493648 0.328683 -0.0652688 -0.328684 0.0 +846 2.75 3.65 41.25 -0.0146925 0.0282769 0.0146967 0.0813637 -0.0282736 -0.0813666 0.0 +847 2.75 3.65 48.75 -0.0246544 0.00490522 0.0246565 0.0166878 -0.00490432 -0.0166888 0.0 +848 2.75 3.65 56.25 -0.0139125 0.00395284 0.0139089 -0.00867723 -0.00395188 0.00867599 0.0 +849 2.75 3.65 63.75 -0.00270241 0.00619066 0.00270068 -0.00571762 -0.00619525 0.00571944 0.0 +850 2.75 3.65 71.25 0.000519918 0.00471435 -0.000521654 -8.15984e-06 -0.00471422 7.2579e-06 0.0 +851 2.75 3.65 78.75 0.000501459 0.00398609 -0.00050026 0.000797399 -0.00398918 -0.000797502 0.0 +852 2.75 3.65 86.25 -4.4671e-05 0.00352149 4.27284e-05 0.000514162 -0.00352011 -0.000514185 0.0 +853 2.75 3.65 93.75 -0.000889969 0.00110883 0.000890202 0.00115235 -0.00110879 -0.00115223 0.0 +854 2.75 3.65 101.25 -0.00151239 -0.00165277 0.00151236 0.00181475 0.00164834 -0.00181365 0.0 +855 2.75 3.65 108.75 -0.00161992 -0.00273717 0.00161755 0.00169929 0.00273792 -0.00169984 0.0 +856 2.75 3.65 116.25 -0.00158692 -0.00271981 0.00158207 0.00119301 0.00272293 -0.00119423 0.0 +857 2.75 3.65 123.75 -0.00161004 -0.0028994 0.00160522 0.000901196 0.00289974 -0.000900406 0.0 +858 2.75 3.65 131.25 -0.00135618 -0.00318701 0.00134929 0.000817217 0.00318514 -0.000815958 0.0 +859 2.75 3.65 138.75 -0.000562397 -0.00258908 0.000562926 0.000632375 0.00259618 -0.000635132 0.0 +860 2.75 3.65 146.25 0.000398525 -0.000673377 -0.000405592 0.000326015 0.000673344 -0.000326095 0.0 +861 2.75 3.65 153.75 0.000850024 0.00202598 -0.000855047 0.000185369 -0.00202081 -0.000188642 0.0 +862 2.75 3.65 161.25 0.000434663 0.00458686 -0.000435573 0.000417059 -0.00458533 -0.000417937 0.0 +863 2.75 3.65 168.75 -0.000552814 0.00638533 0.000542524 0.000898487 -0.00637922 -0.0009015 0.0 +864 2.75 3.65 176.25 -0.00133582 0.00725755 0.00133015 0.00128127 -0.0072543 -0.00128197 0.0 +865 2.85 2.55 3.75 -449.454 -941.562 449.454 9549.73 941.562 -9549.73 0.0 +866 2.85 2.55 11.25 -203.687 -668.13 203.687 3736.46 668.13 -3736.46 0.0 +867 2.85 2.55 18.75 -12.9246 -383.103 12.9246 1213.6 383.103 -1213.6 0.0 +868 2.85 2.55 26.25 63.1921 -179.462 -63.1921 299.966 179.462 -299.966 0.0 +869 2.85 2.55 33.75 62.6546 -65.7116 -62.6546 36.4372 65.7116 -36.4372 0.0 +870 2.85 2.55 41.25 37.3635 -15.6969 -37.3635 -9.14011 15.6969 9.14011 0.0 +871 2.85 2.55 48.75 16.895 0.618772 -16.8951 -7.08679 -0.618757 7.08678 0.0 +872 2.85 2.55 56.25 6.97832 3.39374 -6.97835 -3.15346 -3.39374 3.15347 0.0 +873 2.85 2.55 63.75 3.27315 2.52802 -3.27315 -1.83047 -2.52803 1.83048 0.0 +874 2.85 2.55 71.25 1.70047 1.62582 -1.70071 -1.50656 -1.62582 1.50656 0.0 +875 2.85 2.55 78.75 0.749832 1.27937 -0.749875 -1.51872 -1.27941 1.51871 0.0 +876 2.85 2.55 86.25 0.164393 1.07494 -0.164439 -1.55346 -1.07491 1.55346 0.0 +877 2.85 2.55 93.75 -0.138619 0.673196 0.138741 -1.36215 -0.67314 1.36215 0.0 +878 2.85 2.55 101.25 -0.256642 0.101433 0.256803 -0.949432 -0.10153 0.949443 0.0 +879 2.85 2.55 108.75 -0.221358 -0.430558 0.221453 -0.50286 0.43059 0.502868 0.0 +880 2.85 2.55 116.25 -0.00716267 -0.763914 0.00707724 -0.182642 0.763996 0.182594 0.0 +881 2.85 2.55 123.75 0.389318 -0.868932 -0.38922 -0.0254116 0.869042 0.0254047 0.0 +882 2.85 2.55 131.25 0.89597 -0.814762 -0.896002 0.0246925 0.814838 -0.0247272 0.0 +883 2.85 2.55 138.75 1.38115 -0.710613 -1.3812 0.0482113 0.710584 -0.0481961 0.0 +884 2.85 2.55 146.25 1.7166 -0.656942 -1.71663 0.102514 0.657017 -0.102563 0.0 +885 2.85 2.55 153.75 1.84068 -0.706888 -1.84082 0.204441 0.706832 -0.204425 0.0 +886 2.85 2.55 161.25 1.78401 -0.848447 -1.78392 0.335056 0.848436 -0.335074 0.0 +887 2.85 2.55 168.75 1.64517 -1.0163 -1.64523 0.455943 1.01631 -0.455929 0.0 +888 2.85 2.55 176.25 1.53852 -1.12802 -1.53859 0.528256 1.12801 -0.528249 0.0 +889 2.85 2.65 3.75 -736.234 -953.145 736.234 15002.2 953.145 -15002.2 0.0 +890 2.85 2.65 11.25 -383.861 -632.529 383.861 4732.78 632.529 -4732.78 0.0 +891 2.85 2.65 18.75 -120.397 -336.411 120.397 1474.26 336.411 -1474.26 0.0 +892 2.85 2.65 26.25 1.63758 -143.419 -1.63759 371.726 143.419 -371.726 0.0 +893 2.85 2.65 33.75 28.1679 -47.6669 -28.1678 57.9974 47.6669 -57.9974 0.0 +894 2.85 2.65 41.25 18.5052 -11.7053 -18.5053 -0.0411589 11.7053 0.0411506 0.0 +895 2.85 2.65 48.75 6.98344 -1.71526 -6.98349 -2.25925 1.71528 2.25926 0.0 +896 2.85 2.65 56.25 1.90515 0.189804 -1.9051 -0.694423 -0.189827 0.694421 0.0 +897 2.85 2.65 63.75 0.644706 0.289163 -0.644765 -0.553254 -0.289196 0.553251 0.0 +898 2.85 2.65 71.25 0.358032 0.188047 -0.358068 -0.577658 -0.187995 0.577686 0.0 +899 2.85 2.65 78.75 0.193029 0.186045 -0.193065 -0.576896 -0.186053 0.576887 0.0 +900 2.85 2.65 86.25 0.118081 0.206903 -0.117948 -0.590427 -0.206951 0.590426 0.0 +901 2.85 2.65 93.75 0.116313 0.137487 -0.116341 -0.523115 -0.137426 0.523116 0.0 +902 2.85 2.65 101.25 0.127124 -0.0206052 -0.127264 -0.356029 0.020677 0.356027 0.0 +903 2.85 2.65 108.75 0.134169 -0.192715 -0.134356 -0.167112 0.192721 0.16712 0.0 +904 2.85 2.65 116.25 0.166274 -0.317368 -0.166229 -0.0278194 0.317368 0.02781 0.0 +905 2.85 2.65 123.75 0.250031 -0.376343 -0.250195 0.044687 0.376311 -0.0446765 0.0 +906 2.85 2.65 131.25 0.37155 -0.389541 -0.371651 0.0749583 0.389552 -0.0749598 0.0 +907 2.85 2.65 138.75 0.472028 -0.404165 -0.471849 0.101639 0.404085 -0.101599 0.0 +908 2.85 2.65 146.25 0.482744 -0.473853 -0.482714 0.154822 0.473671 -0.154746 0.0 +909 2.85 2.65 153.75 0.372903 -0.626739 -0.372891 0.24309 0.626702 -0.24306 0.0 +910 2.85 2.65 161.25 0.172204 -0.842652 -0.172283 0.351704 0.842593 -0.351702 0.0 +911 2.85 2.65 168.75 -0.0401177 -1.05637 0.0403128 0.45108 1.05642 -0.451106 0.0 +912 2.85 2.65 176.25 -0.17528 -1.18958 0.175428 0.510384 1.18961 -0.5104 0.0 +913 2.85 2.75 3.75 -979.272 -927.69 979.272 22134.5 927.69 -22134.5 0.0 +914 2.85 2.75 11.25 -526.991 -579.811 526.991 5507.99 579.811 -5507.99 0.0 +915 2.85 2.75 18.75 -204.787 -287.701 204.787 1660.86 287.701 -1660.86 0.0 +916 2.85 2.75 26.25 -45.4274 -109.617 45.4273 419.099 109.617 -419.099 0.0 +917 2.85 2.75 33.75 3.4094 -30.3253 -3.40934 70.6375 30.3253 -70.6375 0.0 +918 2.85 2.75 41.25 6.54385 -5.89301 -6.54392 4.65436 5.89304 -4.65435 0.0 +919 2.85 2.75 48.75 1.87015 -1.12692 -1.87015 -0.0807475 1.12691 0.0807413 0.0 +920 2.85 2.75 56.25 -0.0855468 -0.433007 0.085563 0.253215 0.433018 -0.253203 0.0 +921 2.85 2.75 63.75 -0.193076 -0.180261 0.193218 -0.116602 0.180287 0.11663 0.0 +922 2.85 2.75 71.25 -0.0627372 -0.0669432 0.0628705 -0.266699 0.0669458 0.266713 0.0 +923 2.85 2.75 78.75 -0.00113364 -0.000718484 0.00128081 -0.256413 0.000816792 0.25642 0.0 +924 2.85 2.75 86.25 0.0719457 0.0756041 -0.0719355 -0.25934 -0.0756465 0.25934 0.0 +925 2.85 2.75 93.75 0.150932 0.126391 -0.150887 -0.242532 -0.126415 0.242533 0.0 +926 2.85 2.75 101.25 0.19142 0.122864 -0.191283 -0.177304 -0.122828 0.177291 0.0 +927 2.85 2.75 108.75 0.179151 0.072715 -0.179217 -0.0881976 -0.0726424 0.0881763 0.0 +928 2.85 2.75 116.25 0.132856 -0.00182507 -0.132993 -0.00716005 0.00182425 0.0071526 0.0 +929 2.85 2.75 123.75 0.0849914 -0.0757887 -0.0849411 0.0491728 0.0758462 -0.0491697 0.0 +930 2.85 2.75 131.25 0.0493045 -0.137104 -0.0494332 0.0829233 0.137118 -0.0829226 0.0 +931 2.85 2.75 138.75 0.00591187 -0.201372 -0.00575361 0.111436 0.201482 -0.11145 0.0 +932 2.85 2.75 146.25 -0.0859415 -0.304683 0.0860687 0.155414 0.304665 -0.155395 0.0 +933 2.85 2.75 153.75 -0.248069 -0.47076 0.248108 0.224424 0.470972 -0.224532 0.0 +934 2.85 2.75 161.25 -0.459817 -0.68392 0.459953 0.309867 0.68373 -0.309803 0.0 +935 2.85 2.75 168.75 -0.661906 -0.887629 0.661947 0.389136 0.887641 -0.389112 0.0 +936 2.85 2.75 176.25 -0.785422 -1.01291 0.785357 0.436894 1.01305 -0.436953 0.0 +937 2.85 2.85 3.75 -1116.76 -835.91 1116.76 26640.2 835.91 -26640.2 0.0 +938 2.85 2.85 11.25 -610.386 -506.696 610.386 5875.84 506.696 -5875.84 0.0 +939 2.85 2.85 18.75 -255.208 -239.613 255.208 1744.42 239.613 -1744.42 0.0 +940 2.85 2.85 26.25 -73.7604 -82.5484 73.7603 437.327 82.5484 -437.327 0.0 +941 2.85 2.85 33.75 -11.1104 -18.0796 11.1103 74.9581 18.0796 -74.9581 0.0 +942 2.85 2.85 41.25 0.228715 -1.87052 -0.228784 6.31518 1.87054 -6.31516 0.0 +943 2.85 2.85 48.75 -0.186912 -0.383005 0.186932 0.552533 0.382981 -0.552553 0.0 +944 2.85 2.85 56.25 -0.516548 -0.486964 0.51651 0.427331 0.486994 -0.427316 0.0 +945 2.85 2.85 63.75 -0.277336 -0.279457 0.277442 -0.0294235 0.279516 0.0294254 0.0 +946 2.85 2.85 71.25 -0.12864 -0.127184 0.128869 -0.180718 0.127225 0.180733 0.0 +947 2.85 2.85 78.75 -0.0484987 -0.0475193 0.0484573 -0.172173 0.0474804 0.172167 0.0 +948 2.85 2.85 86.25 0.047169 0.0422314 -0.0471278 -0.173173 -0.0422364 0.173175 0.0 +949 2.85 2.85 93.75 0.132895 0.126705 -0.132882 -0.167927 -0.126598 0.167928 0.0 +950 2.85 2.85 101.25 0.176042 0.170333 -0.17625 -0.134397 -0.170485 0.134408 0.0 +951 2.85 2.85 108.75 0.163576 0.157905 -0.16355 -0.0779511 -0.157842 0.0779731 0.0 +952 2.85 2.85 116.25 0.101997 0.0960507 -0.102078 -0.014347 -0.0959807 0.0143824 0.0 +953 2.85 2.85 123.75 0.0206725 0.0134256 -0.0205836 0.0381676 -0.0135693 -0.0381435 0.0 +954 2.85 2.85 131.25 -0.0539648 -0.0618543 0.0539695 0.071669 0.061813 -0.0716401 0.0 +955 2.85 2.85 138.75 -0.126558 -0.13291 0.126595 0.096029 0.132846 -0.0960093 0.0 +956 2.85 2.85 146.25 -0.226905 -0.229729 0.2268 0.129945 0.229804 -0.130004 0.0 +957 2.85 2.85 153.75 -0.375777 -0.37653 0.375708 0.184542 0.376441 -0.184502 0.0 +958 2.85 2.85 161.25 -0.55951 -0.56228 0.559638 0.254398 0.562318 -0.254441 0.0 +959 2.85 2.85 168.75 -0.731663 -0.739479 0.731781 0.320527 0.739524 -0.32053 0.0 +960 2.85 2.85 176.25 -0.836402 -0.848187 0.836322 0.360778 0.848245 -0.36086 0.0 +961 2.85 2.95 3.75 -1111.67 -671.504 1111.67 23382.6 671.504 -23382.6 0.0 +962 2.85 2.95 11.25 -624.121 -411.338 624.121 5761.08 411.338 -5761.08 0.0 +963 2.85 2.95 18.75 -267.855 -190.585 267.855 1715.29 190.585 -1715.29 0.0 +964 2.85 2.95 26.25 -82.9178 -61.5016 82.9177 426.265 61.5016 -426.265 0.0 +965 2.85 2.95 33.75 -16.5392 -10.9568 16.5393 72.4347 10.9568 -72.4348 0.0 +966 2.85 2.95 41.25 -2.05368 -0.128524 2.05363 6.25085 0.128465 -6.25081 0.0 +967 2.85 2.95 48.75 -0.636623 -0.11763 0.63655 0.514257 0.117589 -0.514248 0.0 +968 2.85 2.95 56.25 -0.408465 -0.491652 0.408393 0.327192 0.491696 -0.327194 0.0 +969 2.85 2.95 63.75 -0.201297 -0.331339 0.201309 -0.0209138 0.331453 0.0209243 0.0 +970 2.85 2.95 71.25 -0.130914 -0.18282 0.130989 -0.130552 0.182746 0.130536 0.0 +971 2.85 2.95 78.75 -0.0608924 -0.0898709 0.0607915 -0.139463 0.0899889 0.139453 0.0 +972 2.85 2.95 86.25 0.0345738 0.00746434 -0.0344701 -0.148244 -0.00754141 0.148234 0.0 +973 2.85 2.95 93.75 0.111119 0.0976325 -0.1113 -0.142909 -0.0978809 0.142911 0.0 +974 2.85 2.95 101.25 0.151941 0.155503 -0.151976 -0.117111 -0.15543 0.11711 0.0 +975 2.85 2.95 108.75 0.145751 0.160353 -0.145553 -0.0726376 -0.160204 0.0725882 0.0 +976 2.85 2.95 116.25 0.0915158 0.110131 -0.0916919 -0.0182529 -0.110235 0.0182768 0.0 +977 2.85 2.95 123.75 0.0152377 0.0331448 -0.0151991 0.0284008 -0.0330236 -0.0284138 0.0 +978 2.85 2.95 131.25 -0.0546463 -0.0389944 0.0545777 0.0573967 0.038874 -0.0573186 0.0 +979 2.85 2.95 138.75 -0.1187 -0.104823 0.118718 0.0772008 0.104764 -0.077174 0.0 +980 2.85 2.95 146.25 -0.204059 -0.191464 0.203984 0.105389 0.191495 -0.105464 0.0 +981 2.85 2.95 153.75 -0.330797 -0.320794 0.330923 0.152322 0.320747 -0.152296 0.0 +982 2.85 2.95 161.25 -0.488129 -0.483077 0.488236 0.213067 0.483198 -0.213056 0.0 +983 2.85 2.95 168.75 -0.635592 -0.636761 0.635765 0.270692 0.636908 -0.270728 0.0 +984 2.85 2.95 176.25 -0.725217 -0.730636 0.725177 0.305753 0.730739 -0.305825 0.0 +985 2.85 3.05 3.75 -991.274 -468.465 991.274 17235.6 468.465 -17235.6 0.0 +986 2.85 3.05 11.25 -573.802 -298.761 573.802 5231.29 298.761 -5231.29 0.0 +987 2.85 3.05 18.75 -246.923 -139.586 246.923 1584.79 139.586 -1584.79 0.0 +988 2.85 3.05 26.25 -76.3431 -44.1795 76.3432 390.143 44.1795 -390.143 0.0 +989 2.85 3.05 33.75 -15.4296 -7.24375 15.4295 64.979 7.24375 -64.979 0.0 +990 2.85 3.05 41.25 -1.99485 0.0867799 1.99484 5.41934 -0.0867462 -5.41932 0.0 +991 2.85 3.05 48.75 -0.466876 -0.194309 0.466823 0.319783 0.194325 -0.319796 0.0 +992 2.85 3.05 56.25 -0.247864 -0.498556 0.247809 0.194278 0.49852 -0.194293 0.0 +993 2.85 3.05 63.75 -0.160838 -0.374237 0.160788 -0.00452736 0.374195 0.00453271 0.0 +994 2.85 3.05 71.25 -0.138726 -0.24602 0.138704 -0.0733155 0.246086 0.0732922 0.0 +995 2.85 3.05 78.75 -0.0645345 -0.137898 0.0646711 -0.10598 0.137892 0.105997 0.0 +996 2.85 3.05 86.25 0.0266641 -0.0289336 -0.0265391 -0.125218 0.0289426 0.125216 0.0 +997 2.85 3.05 93.75 0.0897391 0.0651921 -0.0895906 -0.118986 -0.0650775 0.118989 0.0 +998 2.85 3.05 101.25 0.124171 0.131613 -0.123901 -0.0965881 -0.131532 0.0965755 0.0 +999 2.85 3.05 108.75 0.12195 0.150621 -0.122014 -0.0600585 -0.150659 0.0600667 0.0 +1000 2.85 3.05 116.25 0.0781014 0.115484 -0.0778585 -0.0147582 -0.115247 0.0147179 0.0 +1001 2.85 3.05 123.75 0.0150628 0.0506384 -0.0150425 0.0236392 -0.0506457 -0.023627 0.0 +1002 2.85 3.05 131.25 -0.0400525 -0.0131487 0.0399632 0.0466779 0.0130289 -0.0466525 0.0 +1003 2.85 3.05 138.75 -0.0895184 -0.0739947 0.0894657 0.0627374 0.0740386 -0.0627861 0.0 +1004 2.85 3.05 146.25 -0.15904 -0.155412 0.159469 0.0871229 0.155461 -0.0870861 0.0 +1005 2.85 3.05 153.75 -0.267082 -0.274606 0.267172 0.127796 0.274496 -0.127765 0.0 +1006 2.85 3.05 161.25 -0.401901 -0.419629 0.401826 0.179668 0.41968 -0.179776 0.0 +1007 2.85 3.05 168.75 -0.527756 -0.553697 0.527878 0.228247 0.553582 -0.228199 0.0 +1008 2.85 3.05 176.25 -0.604226 -0.634443 0.604143 0.25757 0.634535 -0.257606 0.0 +1009 2.85 3.15 3.75 -806.102 -265.526 806.102 12165.1 265.526 -12165.1 0.0 +1010 2.85 3.15 11.25 -477.611 -181.207 477.611 4442.53 181.207 -4442.53 0.0 +1011 2.85 3.15 18.75 -202.862 -88.6434 202.862 1380.02 88.6434 -1380.02 0.0 +1012 2.85 3.15 26.25 -60.0987 -29.0515 60.0987 336.188 29.0515 -336.188 0.0 +1013 2.85 3.15 33.75 -10.968 -5.19052 10.9681 54.504 5.19046 -54.5041 0.0 +1014 2.85 3.15 41.25 -1.05094 -0.312006 1.05086 4.33851 0.311981 -4.33846 0.0 +1015 2.85 3.15 48.75 -0.213743 -0.352928 0.213728 0.164252 0.352886 -0.164263 0.0 +1016 2.85 3.15 56.25 -0.154279 -0.471869 0.154225 0.093218 0.47198 -0.0932153 0.0 +1017 2.85 3.15 63.75 -0.141604 -0.388768 0.141653 0.0126807 0.388761 -0.0126585 0.0 +1018 2.85 3.15 71.25 -0.130127 -0.294635 0.130139 -0.0263984 0.294556 0.0263117 0.0 +1019 2.85 3.15 78.75 -0.0550277 -0.180465 0.0550203 -0.073421 0.180561 0.0734297 0.0 +1020 2.85 3.15 86.25 0.0209399 -0.0643701 -0.0207919 -0.0962653 0.0644703 0.0962704 0.0 +1021 2.85 3.15 93.75 0.0659847 0.032253 -0.0661012 -0.0898107 -0.0322317 0.0898055 0.0 +1022 2.85 3.15 101.25 0.0929454 0.104785 -0.092671 -0.0721152 -0.104858 0.0721226 0.0 +1023 2.85 3.15 108.75 0.0923534 0.135562 -0.0925163 -0.0438144 -0.135405 0.0437756 0.0 +1024 2.85 3.15 116.25 0.0576885 0.115491 -0.0573926 -0.00846383 -0.115386 0.00845008 0.0 +1025 2.85 3.15 123.75 0.00835101 0.0659492 -0.00830537 0.0204391 -0.0659776 -0.020473 0.0 +1026 2.85 3.15 131.25 -0.0330033 0.0137364 0.0330472 0.0368218 -0.0138501 -0.0368043 0.0 +1027 2.85 3.15 138.75 -0.0696344 -0.0403338 0.0693805 0.0485567 0.0403552 -0.0486203 0.0 +1028 2.85 3.15 146.25 -0.123646 -0.114761 0.123498 0.0676978 0.114704 -0.0677341 0.0 +1029 2.85 3.15 153.75 -0.209228 -0.220305 0.209164 0.0995682 0.220152 -0.0994412 0.0 +1030 2.85 3.15 161.25 -0.316292 -0.3444 0.316446 0.139549 0.344477 -0.139654 0.0 +1031 2.85 3.15 168.75 -0.416182 -0.455814 0.416144 0.176494 0.455746 -0.176411 0.0 +1032 2.85 3.15 176.25 -0.476042 -0.521785 0.476 0.198621 0.521756 -0.198557 0.0 +1033 2.85 3.25 3.75 -599.006 -91.2154 599.006 8491.46 91.2155 -8491.46 0.0 +1034 2.85 3.25 11.25 -359.488 -74.6727 359.488 3559.49 74.6727 -3559.49 0.0 +1035 2.85 3.25 18.75 -148.661 -42.6777 148.661 1135.12 42.6777 -1135.12 0.0 +1036 2.85 3.25 26.25 -40.7166 -16.0322 40.7166 272.812 16.0322 -272.812 0.0 +1037 2.85 3.25 33.75 -5.97051 -3.67296 5.97039 42.68 3.67297 -42.68 0.0 +1038 2.85 3.25 41.25 -0.182688 -0.670468 0.182753 3.20438 0.670474 -3.20441 0.0 +1039 2.85 3.25 48.75 -0.0747798 -0.425329 0.0748223 0.0657742 0.425365 -0.0658515 0.0 +1040 2.85 3.25 56.25 -0.0982934 -0.398958 0.0982134 0.0220039 0.399004 -0.0220176 0.0 +1041 2.85 3.25 63.75 -0.100813 -0.360976 0.100898 0.0133885 0.360825 -0.0133447 0.0 +1042 2.85 3.25 71.25 -0.0945309 -0.307881 0.0945963 -0.00420512 0.307879 0.00421061 0.0 +1043 2.85 3.25 78.75 -0.0366795 -0.207353 0.0366632 -0.0482296 0.20741 0.0482248 0.0 +1044 2.85 3.25 86.25 0.0149887 -0.0970942 -0.0150626 -0.0654125 0.0972336 0.0654212 0.0 +1045 2.85 3.25 93.75 0.0443972 -0.00226785 -0.0443982 -0.0599009 0.00218497 0.0598939 0.0 +1046 2.85 3.25 101.25 0.0653842 0.0743707 -0.0655475 -0.0488889 -0.074459 0.048906 0.0 +1047 2.85 3.25 108.75 0.0673028 0.115282 -0.0672563 -0.0293956 -0.115121 0.0293551 0.0 +1048 2.85 3.25 116.25 0.041101 0.109791 -0.041206 -0.00426137 -0.110092 0.0043584 0.0 +1049 2.85 3.25 123.75 0.0030353 0.0756594 -0.00306469 0.0153374 -0.0756692 -0.0152926 0.0 +1050 2.85 3.25 131.25 -0.02782 0.0350328 0.0279329 0.0256415 -0.0350474 -0.0256136 0.0 +1051 2.85 3.25 138.75 -0.0538742 -0.00966993 0.0537414 0.0330967 0.00970634 -0.033162 0.0 +1052 2.85 3.25 146.25 -0.0905357 -0.070843 0.0905608 0.0460454 0.0707919 -0.045972 0.0 +1053 2.85 3.25 153.75 -0.14887 -0.15562 0.148901 0.0676893 0.155618 -0.067644 0.0 +1054 2.85 3.25 161.25 -0.22216 -0.252709 0.22219 0.0946651 0.252847 -0.0946834 0.0 +1055 2.85 3.25 168.75 -0.290593 -0.338691 0.290381 0.119487 0.33884 -0.119576 0.0 +1056 2.85 3.25 176.25 -0.3308 -0.388801 0.331427 0.13433 0.388853 -0.134296 0.0 +1057 2.85 3.35 3.75 -386.528 33.5021 386.528 5634.36 -33.5021 -5634.36 0.0 +1058 2.85 3.35 11.25 -232.313 5.67109 232.313 2604.32 -5.67109 -2604.32 0.0 +1059 2.85 3.35 18.75 -91.9697 -7.27714 91.9697 849.253 7.27716 -849.253 0.0 +1060 2.85 3.35 26.25 -22.1609 -5.78613 22.161 200.148 5.78612 -200.148 0.0 +1061 2.85 3.35 33.75 -1.98022 -2.12648 1.98024 29.7672 2.12648 -29.7672 0.0 +1062 2.85 3.35 41.25 0.243179 -0.637377 -0.243178 2.04091 0.637344 -2.04094 0.0 +1063 2.85 3.35 48.75 -0.0543799 -0.361761 0.0543227 0.0128587 0.36182 -0.0128186 0.0 +1064 2.85 3.35 56.25 -0.053243 -0.315179 0.0533037 -0.0175621 0.315135 0.0175499 0.0 +1065 2.85 3.35 63.75 -0.0463022 -0.314223 0.0463235 0.00311652 0.314212 -0.00320789 0.0 +1066 2.85 3.35 71.25 -0.0532898 -0.296211 0.0534137 -0.000155585 0.29602 0.000135295 0.0 +1067 2.85 3.35 78.75 -0.0212587 -0.22246 0.0212696 -0.0288431 0.222559 0.0288631 0.0 +1068 2.85 3.35 86.25 0.00889954 -0.125343 -0.00894718 -0.0369629 0.125394 0.0369644 0.0 +1069 2.85 3.35 93.75 0.0262325 -0.0313862 -0.0263584 -0.0340369 0.0311982 0.0340506 0.0 +1070 2.85 3.35 101.25 0.0415953 0.0498466 -0.0414478 -0.0293926 -0.0498895 0.0293844 0.0 +1071 2.85 3.35 108.75 0.0450451 0.0995096 -0.0449831 -0.0178232 -0.0997351 0.0178778 0.0 +1072 2.85 3.35 116.25 0.028077 0.105738 -0.0281433 -0.00230595 -0.105795 0.00235292 0.0 +1073 2.85 3.35 123.75 0.00116088 0.0815732 -0.000852722 0.00942911 -0.0816637 -0.00933158 0.0 +1074 2.85 3.35 131.25 -0.0216069 0.0479562 0.0217652 0.0156247 -0.0476846 -0.0157325 0.0 +1075 2.85 3.35 138.75 -0.0380909 0.0111308 0.0380157 0.0201099 -0.0113054 -0.0200733 0.0 +1076 2.85 3.35 146.25 -0.0570642 -0.0359703 0.0570676 0.0273788 0.0359094 -0.0273053 0.0 +1077 2.85 3.35 153.75 -0.0874487 -0.0993169 0.0874531 0.0394423 0.0994037 -0.0393806 0.0 +1078 2.85 3.35 161.25 -0.127843 -0.172492 0.127557 0.054893 0.172359 -0.0549082 0.0 +1079 2.85 3.35 168.75 -0.166559 -0.237682 0.166614 0.0695468 0.237554 -0.0695277 0.0 +1080 2.85 3.35 176.25 -0.191 -0.276276 0.19078 0.0784958 0.276377 -0.0785403 0.0 +1081 2.85 3.45 3.75 -161.588 70.6187 161.588 2741.33 -70.6187 -2741.33 0.0 +1082 2.85 3.45 11.25 -95.5114 34.9158 95.5114 1355.81 -34.9158 -1355.81 0.0 +1083 2.85 3.45 18.75 -34.6683 8.27267 34.6684 448.865 -8.27268 -448.865 0.0 +1084 2.85 3.45 26.25 -6.16493 -0.139582 6.16494 102.857 0.139618 -102.857 0.0 +1085 2.85 3.45 33.75 0.422229 -0.589501 -0.422207 14.2949 0.589425 -14.2948 0.0 +1086 2.85 3.45 41.25 0.271293 -0.179716 -0.271334 0.90093 0.179724 -0.900935 0.0 +1087 2.85 3.45 48.75 -0.0728654 -0.170806 0.0729137 0.0252674 0.1707 -0.025252 0.0 +1088 2.85 3.45 56.25 -0.0333377 -0.213039 0.0332742 -0.0156257 0.212999 0.0155434 0.0 +1089 2.85 3.45 63.75 -0.0152903 -0.227014 0.0151849 -0.00379666 0.227029 0.00381385 0.0 +1090 2.85 3.45 71.25 -0.0235692 -0.224061 0.0235144 -0.000903934 0.22407 0.000862594 0.0 +1091 2.85 3.45 78.75 -0.00941949 -0.180683 0.00940751 -0.0122182 0.180688 0.0122354 0.0 +1092 2.85 3.45 86.25 0.00386563 -0.108855 -0.00384482 -0.0147672 0.108894 0.0147696 0.0 +1093 2.85 3.45 93.75 0.00738598 -0.0352297 -0.00746621 -0.0134146 0.0352537 0.0134097 0.0 +1094 2.85 3.45 101.25 0.0113163 0.0272447 -0.0112177 -0.0108832 -0.027162 0.0109037 0.0 +1095 2.85 3.45 108.75 0.0143535 0.0674421 -0.0144727 -0.00585159 -0.0674317 0.00583747 0.0 +1096 2.85 3.45 116.25 0.0102386 0.0775271 -0.0102071 -0.000339014 -0.0776401 0.000348303 0.0 +1097 2.85 3.45 123.75 2.58732e-05 0.0640245 -4.10589e-05 0.00384167 -0.0641439 -0.00376402 0.0 +1098 2.85 3.45 131.25 -0.00902431 0.0415235 0.00900971 0.00644527 -0.0416055 -0.00641701 0.0 +1099 2.85 3.45 138.75 -0.0130822 0.0181696 0.0131824 0.00773263 -0.0182103 -0.00771311 0.0 +1100 2.85 3.45 146.25 -0.0161839 -0.00998922 0.016076 0.00888536 0.00978667 -0.00879601 0.0 +1101 2.85 3.45 153.75 -0.0242202 -0.0483692 0.0241807 0.011811 0.0483358 -0.0118472 0.0 +1102 2.85 3.45 161.25 -0.0396328 -0.0952296 0.0395522 0.0172745 0.0951821 -0.0172176 0.0 +1103 2.85 3.45 168.75 -0.0578248 -0.139644 0.0577311 0.0236934 0.13953 -0.0236387 0.0 +1104 2.85 3.45 176.25 -0.0700834 -0.166806 0.0701114 0.0280544 0.166621 -0.0279388 0.0 +1105 2.85 3.55 3.75 -31.029 33.8429 31.029 807.354 -33.8429 -807.354 0.0 +1106 2.85 3.55 11.25 -16.6941 17.1581 16.6942 418.065 -17.1581 -418.065 0.0 +1107 2.85 3.55 18.75 -3.99472 4.08748 3.9947 139.471 -4.08747 -139.471 0.0 +1108 2.85 3.55 26.25 0.82754 0.00960473 -0.827538 30.9637 -0.00959943 -30.9637 0.0 +1109 2.85 3.55 33.75 0.904557 -0.081934 -0.904543 4.11608 0.0819614 -4.11609 0.0 +1110 2.85 3.55 41.25 0.170681 0.0848305 -0.170682 0.346509 -0.0848039 -0.34653 0.0 +1111 2.85 3.55 48.75 -0.0666717 -0.0106917 0.0666836 0.0541797 0.0106909 -0.0541811 0.0 +1112 2.85 3.55 56.25 -0.0367163 -0.0711844 0.0367427 -0.00758183 0.0712025 0.00758489 0.0 +1113 2.85 3.55 63.75 -0.00980718 -0.0797592 0.00983424 -0.00697712 0.0797424 0.00697812 0.0 +1114 2.85 3.55 71.25 -0.00586824 -0.0828521 0.00590764 -3.50261e-07 0.0828154 -9.47724e-06 0.0 +1115 2.85 3.55 78.75 -0.000602709 -0.0682983 0.000612821 -0.00212227 0.0683145 0.00213184 0.0 +1116 2.85 3.55 86.25 0.000973121 -0.0398569 -0.000961009 -0.00335451 0.0398316 0.00334909 0.0 +1117 2.85 3.55 93.75 -0.00358082 -0.0150889 0.00357048 -0.00152868 0.0150508 0.00152981 0.0 +1118 2.85 3.55 101.25 -0.00603736 0.00394172 0.00605293 0.000730934 -0.00393071 -0.000744155 0.0 +1119 2.85 3.55 108.75 -0.00335262 0.0195109 0.00322804 0.00102238 -0.0194668 -0.00104163 0.0 +1120 2.85 3.55 116.25 0.000444349 0.027755 -0.000387332 8.69624e-05 -0.0277462 -9.75392e-05 0.0 +1121 2.85 3.55 123.75 0.0014088 0.0269113 -0.00138674 -7.73086e-05 -0.0268849 6.29337e-05 0.0 +1122 2.85 3.55 131.25 0.00165964 0.0217477 -0.00165364 0.000223061 -0.0218041 -0.000187964 0.0 +1123 2.85 3.55 138.75 0.00401875 0.0169663 -0.00395318 -0.000703326 -0.016976 0.000717988 0.0 +1124 2.85 3.55 146.25 0.00768509 0.0118145 -0.00765824 -0.00287592 -0.0118411 0.00289573 0.0 +1125 2.85 3.55 153.75 0.00912573 0.00261415 -0.00905729 -0.00443259 -0.00257542 0.00443667 0.0 +1126 2.85 3.55 161.25 0.0057808 -0.0119115 -0.00584887 -0.00390544 0.0118818 0.00391874 0.0 +1127 2.85 3.55 168.75 -0.000422092 -0.0276521 0.000431626 -0.00177835 0.0276894 0.00174946 0.0 +1128 2.85 3.55 176.25 -0.00538109 -0.0379719 0.00540295 7.43942e-05 0.0379802 -5.26705e-05 0.0 +1129 2.85 3.65 3.75 0.117993 2.41395 -0.117994 63.6242 -2.41395 -63.6242 0.0 +1130 2.85 3.65 11.25 0.547196 0.863222 -0.547196 34.0061 -0.86322 -34.0061 0.0 +1131 2.85 3.65 18.75 0.745937 -0.193692 -0.745936 11.4296 0.193693 -11.4296 0.0 +1132 2.85 3.65 26.25 0.543519 -0.28335 -0.54352 2.53726 0.28335 -2.53726 0.0 +1133 2.85 3.65 33.75 0.224853 -0.0795795 -0.224852 0.395802 0.0795803 -0.395805 0.0 +1134 2.85 3.65 41.25 0.0308566 0.0096513 -0.030854 0.0760108 -0.00965396 -0.0760089 0.0 +1135 2.85 3.65 48.75 -0.0200071 0.0114374 0.0200007 0.0152694 -0.0114346 -0.0152666 0.0 +1136 2.85 3.65 56.25 -0.0121781 0.00806958 0.0121778 -0.00463886 -0.00806824 0.00463935 0.0 +1137 2.85 3.65 63.75 -0.00240079 0.00691829 0.00239728 -0.00287853 -0.00691891 0.00287832 0.0 +1138 2.85 3.65 71.25 -0.000113974 0.00344927 0.000114402 0.000925612 -0.00345159 -0.000924517 0.0 +1139 2.85 3.65 78.75 -0.000150972 0.00204618 0.000149514 0.00127176 -0.00204528 -0.00127259 0.0 +1140 2.85 3.65 86.25 -0.00063721 0.00167632 0.000641885 0.000872705 -0.00167479 -0.000872293 0.0 +1141 2.85 3.65 93.75 -0.00144962 -0.000316034 0.00144811 0.00113858 0.000313733 -0.00113842 0.0 +1142 2.85 3.65 101.25 -0.00167523 -0.00216785 0.00167369 0.00123363 0.00216868 -0.00123425 0.0 +1143 2.85 3.65 108.75 -0.00110878 -0.00207464 0.00110977 0.00064396 0.00207751 -0.000643732 0.0 +1144 2.85 3.65 116.25 -0.000764004 -0.00128655 0.000766131 0.000103318 0.00128453 -0.000103182 0.0 +1145 2.85 3.65 123.75 -0.00123412 -0.00134957 0.00123183 0.000216939 0.00135724 -0.000220275 0.0 +1146 2.85 3.65 131.25 -0.00184917 -0.00183778 0.00184664 0.000577507 0.00184059 -0.000579396 0.0 +1147 2.85 3.65 138.75 -0.00163391 -0.00138008 0.00162307 0.000515544 0.00137553 -0.000512344 0.0 +1148 2.85 3.65 146.25 -0.000376327 0.000499681 0.00037387 -6.6379e-06 -0.000506003 1.01884e-05 0.0 +1149 2.85 3.65 153.75 0.00121458 0.00310539 -0.00122162 -0.000485719 -0.00311088 0.000488173 0.0 +1150 2.85 3.65 161.25 0.00238865 0.00543453 -0.0023833 -0.00051915 -0.00542809 0.000516147 0.0 +1151 2.85 3.65 168.75 0.00285962 0.00692717 -0.00285792 -0.000171476 -0.00692344 0.000168255 0.0 +1152 2.85 3.65 176.25 0.00292307 0.00758779 -0.00292581 0.00016883 -0.00759567 -0.000164093 0.0 +1153 2.95 2.55 3.75 -252.721 -1050.76 252.721 6595.19 1050.76 -6595.19 0.0 +1154 2.95 2.55 11.25 -41.1238 -768.829 41.1238 2888.85 768.829 -2888.85 0.0 +1155 2.95 2.55 18.75 118.417 -449.255 -118.417 900.553 449.255 -900.553 0.0 +1156 2.95 2.55 26.25 156.92 -210.895 -156.92 167.43 210.895 -167.43 0.0 +1157 2.95 2.55 33.75 119.104 -74.0526 -119.104 -18.6078 74.0526 18.6078 0.0 +1158 2.95 2.55 41.25 65.7986 -13.1995 -65.7986 -30.6797 13.1995 30.6797 0.0 +1159 2.95 2.55 48.75 29.0332 5.91326 -29.0332 -15.4024 -5.91326 15.4024 0.0 +1160 2.95 2.55 56.25 11.4878 8.02601 -11.4878 -6.73731 -8.026 6.7373 0.0 +1161 2.95 2.55 63.75 4.66214 5.91098 -4.66202 -3.9881 -5.91102 3.98809 0.0 +1162 2.95 2.55 71.25 1.77619 4.12825 -1.77611 -3.46574 -4.12825 3.46573 0.0 +1163 2.95 2.55 78.75 0.151273 3.12532 -0.151223 -3.50261 -3.12532 3.50263 0.0 +1164 2.95 2.55 86.25 -0.848703 2.18442 0.848724 -3.31518 -2.18449 3.31517 0.0 +1165 2.95 2.55 93.75 -1.36638 0.946406 1.36638 -2.63915 -0.946487 2.63915 0.0 +1166 2.95 2.55 101.25 -1.42623 -0.377787 1.42617 -1.69714 0.377648 1.69715 0.0 +1167 2.95 2.55 108.75 -0.982806 -1.42876 0.982806 -0.865233 1.42871 0.865248 0.0 +1168 2.95 2.55 116.25 -0.0278435 -2.03668 0.0278263 -0.352266 2.0367 0.352236 0.0 +1169 2.95 2.55 123.75 1.31816 -2.25352 -1.31823 -0.14086 2.25366 0.140835 0.0 +1170 2.95 2.55 131.25 2.8161 -2.2369 -2.81616 -0.0975587 2.2368 0.0975804 0.0 +1171 2.95 2.55 138.75 4.19661 -2.14695 -4.1966 -0.0893642 2.14695 0.0893633 0.0 +1172 2.95 2.55 146.25 5.25737 -2.09866 -5.25733 -0.0396033 2.09866 0.0396395 0.0 +1173 2.95 2.55 153.75 5.92169 -2.14378 -5.92174 0.0676359 2.14379 -0.0676218 0.0 +1174 2.95 2.55 161.25 6.2371 -2.26995 -6.23714 0.206683 2.26994 -0.206718 0.0 +1175 2.95 2.55 168.75 6.32882 -2.41823 -6.32875 0.334294 2.41818 -0.334278 0.0 +1176 2.95 2.55 176.25 6.33197 -2.5165 -6.33197 0.409999 2.51647 -0.40999 0.0 +1177 2.95 2.65 3.75 -602.404 -1044.08 602.403 10359.8 1044.08 -10359.8 0.0 +1178 2.95 2.65 11.25 -280.258 -724.735 280.258 3883.61 724.735 -3883.61 0.0 +1179 2.95 2.65 18.75 -31.2855 -399.161 31.2855 1185.42 399.161 -1185.42 0.0 +1180 2.95 2.65 26.25 67.6443 -176.276 -67.6443 254.871 176.276 -254.871 0.0 +1181 2.95 2.65 33.75 67.6221 -60.3361 -67.6221 13.3469 60.3361 -13.3469 0.0 +1182 2.95 2.65 41.25 37.2303 -14.1507 -37.2303 -15.1485 14.1507 15.1485 0.0 +1183 2.95 2.65 48.75 14.0035 -0.570849 -14.0035 -7.01654 0.570878 7.01655 0.0 +1184 2.95 2.65 56.25 3.96826 1.75692 -3.96826 -2.30424 -1.75694 2.30425 0.0 +1185 2.95 2.65 63.75 1.03968 1.41412 -1.03973 -1.31005 -1.41411 1.31004 0.0 +1186 2.95 2.65 71.25 0.218951 0.967353 -0.218964 -1.22938 -0.967351 1.22938 0.0 +1187 2.95 2.65 78.75 -0.174997 0.772767 0.175075 -1.2882 -0.772773 1.2882 0.0 +1188 2.95 2.65 86.25 -0.393839 0.559177 0.393914 -1.24166 -0.559238 1.24165 0.0 +1189 2.95 2.65 93.75 -0.47265 0.167892 0.472634 -0.971798 -0.167863 0.971793 0.0 +1190 2.95 2.65 101.25 -0.415086 -0.29444 0.415096 -0.582018 0.294494 0.582025 0.0 +1191 2.95 2.65 108.75 -0.18344 -0.657303 0.1835 -0.251448 0.657204 0.251466 0.0 +1192 2.95 2.65 116.25 0.242862 -0.853042 -0.242735 -0.0667618 0.853138 0.0667293 0.0 +1193 2.95 2.65 123.75 0.816898 -0.9163 -0.817068 -0.00551971 0.916326 0.00551894 0.0 +1194 2.95 2.65 131.25 1.43137 -0.918518 -1.43133 0.000272837 0.918644 -0.000308227 0.0 +1195 2.95 2.65 138.75 1.95867 -0.929005 -1.95862 0.0112189 0.929075 -0.011238 0.0 +1196 2.95 2.65 146.25 2.30364 -0.998983 -2.30361 0.0592927 0.99898 -0.059327 0.0 +1197 2.95 2.65 153.75 2.4381 -1.14713 -2.43811 0.146803 1.14716 -0.146836 0.0 +1198 2.95 2.65 161.25 2.40678 -1.34935 -2.40669 0.254078 1.34942 -0.254097 0.0 +1199 2.95 2.65 168.75 2.30131 -1.54572 -2.3013 0.350716 1.54578 -0.350713 0.0 +1200 2.95 2.65 176.25 2.21842 -1.66688 -2.21834 0.407733 1.66692 -0.407764 0.0 +1201 2.95 2.75 3.75 -921.349 -993.633 921.349 15774.2 993.633 -15774.2 0.0 +1202 2.95 2.75 11.25 -484.503 -651.799 484.503 4799.82 651.799 -4799.82 0.0 +1203 2.95 2.75 18.75 -156.849 -336.509 156.849 1421.48 336.509 -1421.48 0.0 +1204 2.95 2.75 26.25 -5.03783 -135.732 5.03782 322.829 135.732 -322.829 0.0 +1205 2.95 2.75 33.75 28.3547 -41.434 -28.3547 36.1083 41.434 -36.1083 0.0 +1206 2.95 2.75 41.25 17.8836 -9.27057 -17.8837 -5.3871 9.27056 5.38709 0.0 +1207 2.95 2.75 48.75 5.55648 -1.46767 -5.55657 -2.51898 1.46764 2.519 0.0 +1208 2.95 2.75 56.25 0.672106 -0.0883279 -0.672198 -0.334779 0.0883496 0.334765 0.0 +1209 2.95 2.75 63.75 -0.194927 0.0690679 0.194963 -0.280915 -0.0690525 0.280893 0.0 +1210 2.95 2.75 71.25 -0.206856 0.0649187 0.206763 -0.378435 -0.0649176 0.378425 0.0 +1211 2.95 2.75 78.75 -0.186711 0.113908 0.186572 -0.418937 -0.113823 0.418941 0.0 +1212 2.95 2.75 86.25 -0.14961 0.156382 0.149622 -0.426505 -0.156396 0.426506 0.0 +1213 2.95 2.75 93.75 -0.0954388 0.111367 0.0953423 -0.345344 -0.111332 0.345334 0.0 +1214 2.95 2.75 101.25 -0.0328122 0.00794576 0.032972 -0.207227 -0.00797229 0.207241 0.0 +1215 2.95 2.75 108.75 0.054673 -0.0891922 -0.0546091 -0.0841935 0.0892434 0.0841691 0.0 +1216 2.95 2.75 116.25 0.181234 -0.157367 -0.181265 -0.0087282 0.157339 0.00873243 0.0 +1217 2.95 2.75 123.75 0.34012 -0.205051 -0.340198 0.0264405 0.205132 -0.0264545 0.0 +1218 2.95 2.75 131.25 0.502317 -0.247373 -0.502348 0.0429474 0.247218 -0.0428813 0.0 +1219 2.95 2.75 138.75 0.621852 -0.305681 -0.622162 0.0628186 0.305576 -0.0628133 0.0 +1220 2.95 2.75 146.25 0.656682 -0.406771 -0.656592 0.101823 0.406971 -0.101931 0.0 +1221 2.95 2.75 153.75 0.591488 -0.564489 -0.591646 0.163918 0.564573 -0.163963 0.0 +1222 2.95 2.75 161.25 0.454619 -0.760373 -0.454635 0.239232 0.760289 -0.2392 0.0 +1223 2.95 2.75 168.75 0.305915 -0.944156 -0.305938 0.307995 0.944217 -0.308028 0.0 +1224 2.95 2.75 176.25 0.210804 -1.05602 -0.210888 0.349082 1.05601 -0.34907 0.0 +1225 2.95 2.85 3.75 -1152.1 -884.325 1152.1 22433.3 884.325 -22433.3 0.0 +1226 2.95 2.85 11.25 -623.249 -554.368 623.249 5446.55 554.368 -5446.55 0.0 +1227 2.95 2.85 18.75 -243.026 -270.991 243.026 1573.49 270.991 -1573.49 0.0 +1228 2.95 2.85 26.25 -54.9922 -98.9789 54.9921 364.541 98.9789 -364.541 0.0 +1229 2.95 2.85 33.75 2.25373 -25.1037 -2.25376 49.691 25.1036 -49.691 0.0 +1230 2.95 2.85 41.25 6.24999 -4.21281 -6.25004 -0.0158362 4.21279 0.015854 0.0 +1231 2.95 2.85 48.75 1.46896 -0.83917 -1.46896 -0.516745 0.839147 0.51676 0.0 +1232 2.95 2.85 56.25 -0.371828 -0.443561 0.371951 0.300591 0.443459 -0.300568 0.0 +1233 2.95 2.85 63.75 -0.390584 -0.244547 0.39061 -0.00488443 0.244578 0.00485482 0.0 +1234 2.95 2.85 71.25 -0.227523 -0.141639 0.22751 -0.135266 0.141661 0.135279 0.0 +1235 2.95 2.85 78.75 -0.13169 -0.0500631 0.131746 -0.158901 0.0499834 0.158894 0.0 +1236 2.95 2.85 86.25 -0.0383226 0.048949 0.0384519 -0.178632 -0.048876 0.178639 0.0 +1237 2.95 2.85 93.75 0.0424506 0.108468 -0.0424569 -0.162363 -0.108402 0.162362 0.0 +1238 2.95 2.85 101.25 0.0951102 0.123599 -0.0950067 -0.114705 -0.123527 0.114684 0.0 +1239 2.95 2.85 108.75 0.118329 0.108127 -0.118294 -0.059624 -0.107977 0.0595957 0.0 +1240 2.95 2.85 116.25 0.115747 0.0657013 -0.115496 -0.00921956 -0.0657449 0.00923083 0.0 +1241 2.95 2.85 123.75 0.0997312 0.00632325 -0.0998366 0.0300757 -0.00638085 -0.0300905 0.0 +1242 2.95 2.85 131.25 0.0820412 -0.0544768 -0.0820477 0.0562421 0.0545567 -0.0562266 0.0 +1243 2.95 2.85 138.75 0.0543383 -0.118472 -0.0543542 0.0766667 0.118496 -0.0766528 0.0 +1244 2.95 2.85 146.25 -0.00685308 -0.206793 0.00693165 0.104336 0.206705 -0.104299 0.0 +1245 2.95 2.85 153.75 -0.116153 -0.336589 0.116017 0.147362 0.336516 -0.147325 0.0 +1246 2.95 2.85 161.25 -0.2593 -0.497512 0.259351 0.201965 0.497407 -0.201901 0.0 +1247 2.95 2.85 168.75 -0.396397 -0.649488 0.396361 0.253751 0.649379 -0.253726 0.0 +1248 2.95 2.85 176.25 -0.480441 -0.742274 0.480289 0.285392 0.74211 -0.285331 0.0 +1249 2.95 2.95 3.75 -1235.79 -703.549 1235.79 26126.6 703.549 -26126.6 0.0 +1250 2.95 2.95 11.25 -677.675 -435.614 677.675 5671.31 435.614 -5671.31 0.0 +1251 2.95 2.95 18.75 -281.882 -206.464 281.882 1620.38 206.464 -1620.38 0.0 +1252 2.95 2.95 26.25 -80.142 -69.4145 80.142 377.367 69.4145 -377.367 0.0 +1253 2.95 2.95 33.75 -11.535 -14.0454 11.535 55.1741 14.0454 -55.1741 0.0 +1254 2.95 2.95 41.25 0.444691 -1.06867 -0.444678 2.44606 1.06872 -2.44609 0.0 +1255 2.95 2.95 48.75 -0.095339 -0.280002 0.095379 0.150135 0.280037 -0.150155 0.0 +1256 2.95 2.95 56.25 -0.487332 -0.457247 0.487298 0.373103 0.457341 -0.373058 0.0 +1257 2.95 2.95 63.75 -0.309733 -0.308057 0.309669 0.0352679 0.308082 -0.0352801 0.0 +1258 2.95 2.95 71.25 -0.189494 -0.187337 0.189429 -0.0767338 0.187338 0.0767722 0.0 +1259 2.95 2.95 78.75 -0.100558 -0.0943326 0.100538 -0.103742 0.0942838 0.103711 0.0 +1260 2.95 2.95 86.25 -0.00127159 0.00259697 0.00111691 -0.124177 -0.0027075 0.124174 0.0 +1261 2.95 2.95 93.75 0.0781938 0.0795056 -0.0783669 -0.119644 -0.0795165 0.119632 0.0 +1262 2.95 2.95 101.25 0.125437 0.125749 -0.125346 -0.0954926 -0.125695 0.0954816 0.0 +1263 2.95 2.95 108.75 0.131842 0.132451 -0.1318 -0.0582993 -0.132316 0.0582686 0.0 +1264 2.95 2.95 116.25 0.094036 0.0945768 -0.0939986 -0.013007 -0.0944018 0.0129685 0.0 +1265 2.95 2.95 123.75 0.031853 0.0309302 -0.0318676 0.0276584 -0.0309157 -0.0276663 0.0 +1266 2.95 2.95 131.25 -0.0289236 -0.0307662 0.0290267 0.0542911 0.0309129 -0.0543246 0.0 +1267 2.95 2.95 138.75 -0.0860191 -0.0873603 0.0858184 0.0715543 0.0871918 -0.0715138 0.0 +1268 2.95 2.95 146.25 -0.159015 -0.159395 0.158823 0.092785 0.159333 -0.0927604 0.0 +1269 2.95 2.95 153.75 -0.264066 -0.265928 0.264092 0.127317 0.266003 -0.127385 0.0 +1270 2.95 2.95 161.25 -0.392832 -0.399313 0.392736 0.172881 0.399453 -0.172904 0.0 +1271 2.95 2.95 168.75 -0.51305 -0.525949 0.512818 0.216982 0.526087 -0.217102 0.0 +1272 2.95 2.95 176.25 -0.585362 -0.603164 0.585535 0.244165 0.603114 -0.244128 0.0 +1273 2.95 3.05 3.75 -1152 -470.691 1152 22546.9 470.691 -22546.9 0.0 +1274 2.95 3.05 11.25 -646.366 -302.989 646.366 5436.44 302.989 -5436.44 0.0 +1275 2.95 3.05 18.75 -274.735 -144.566 274.735 1560.79 144.566 -1560.79 0.0 +1276 2.95 3.05 26.25 -82.9595 -46.7837 82.9596 363.128 46.7837 -363.128 0.0 +1277 2.95 3.05 33.75 -15.5348 -7.90904 15.5348 54.2888 7.90907 -54.2887 0.0 +1278 2.95 3.05 41.25 -1.52533 0.0877815 1.52529 3.23039 -0.0877658 -3.23043 0.0 +1279 2.95 3.05 48.75 -0.429791 -0.130249 0.429777 0.249314 0.130206 -0.249273 0.0 +1280 2.95 3.05 56.25 -0.354386 -0.465805 0.3544 0.285906 0.465883 -0.285905 0.0 +1281 2.95 3.05 63.75 -0.230807 -0.353693 0.230714 0.0451008 0.353768 -0.0451234 0.0 +1282 2.95 3.05 71.25 -0.171943 -0.228248 0.172051 -0.0442061 0.228171 0.0442394 0.0 +1283 2.95 3.05 78.75 -0.0886759 -0.125763 0.0886157 -0.0870429 0.125748 0.0870611 0.0 +1284 2.95 3.05 86.25 0.00406016 -0.0290639 -0.00400943 -0.106637 0.0291333 0.106635 0.0 +1285 2.95 3.05 93.75 0.0709324 0.0512843 -0.0709031 -0.0997352 -0.0513256 0.0997471 0.0 +1286 2.95 3.05 101.25 0.112173 0.109307 -0.112111 -0.081026 -0.10938 0.0810188 0.0 +1287 2.95 3.05 108.75 0.118241 0.127448 -0.118156 -0.0508854 -0.127498 0.0509172 0.0 +1288 2.95 3.05 116.25 0.082375 0.0967194 -0.0826216 -0.0115758 -0.096743 0.0116038 0.0 +1289 2.95 3.05 123.75 0.0249719 0.0392243 -0.0250633 0.0233571 -0.0393156 -0.0232965 0.0 +1290 2.95 3.05 131.25 -0.0283614 -0.0168684 0.0282743 0.0451621 0.0168661 -0.045173 0.0 +1291 2.95 3.05 138.75 -0.0768736 -0.0688048 0.077069 0.0594051 0.068716 -0.0593073 0.0 +1292 2.95 3.05 146.25 -0.141563 -0.136731 0.141568 0.0784955 0.136426 -0.0784076 0.0 +1293 2.95 3.05 153.75 -0.236122 -0.235072 0.236058 0.109983 0.235346 -0.110141 0.0 +1294 2.95 3.05 161.25 -0.351579 -0.354851 0.351474 0.150951 0.354689 -0.150832 0.0 +1295 2.95 3.05 168.75 -0.458428 -0.465918 0.458345 0.190063 0.465592 -0.18999 0.0 +1296 2.95 3.05 176.25 -0.522577 -0.532559 0.52258 0.213967 0.532625 -0.214084 0.0 +1297 2.95 3.15 3.75 -947.105 -234.064 947.105 16388.2 234.064 -16388.2 0.0 +1298 2.95 3.15 11.25 -544.957 -169.572 544.957 4831.85 169.572 -4831.85 0.0 +1299 2.95 3.15 18.75 -231.218 -87.4264 231.218 1411.96 87.4264 -1411.96 0.0 +1300 2.95 3.15 26.25 -69.489 -29.5946 69.489 327.211 29.5945 -327.211 0.0 +1301 2.95 3.15 33.75 -13.2484 -5.06717 13.2484 48.9414 5.06717 -48.9414 0.0 +1302 2.95 3.15 41.25 -1.4679 0.0238403 1.46795 3.15011 -0.0239097 -3.15014 0.0 +1303 2.95 3.15 48.75 -0.31652 -0.227201 0.316586 0.172569 0.227204 -0.17262 0.0 +1304 2.95 3.15 56.25 -0.21369 -0.480095 0.213689 0.184024 0.480141 -0.184087 0.0 +1305 2.95 3.15 63.75 -0.176969 -0.390853 0.176921 0.0560194 0.390826 -0.0559763 0.0 +1306 2.95 3.15 71.25 -0.150417 -0.269717 0.150456 -0.0151382 0.269771 0.0150882 0.0 +1307 2.95 3.15 78.75 -0.0732588 -0.158111 0.073298 -0.0675252 0.157991 0.0675219 0.0 +1308 2.95 3.15 86.25 0.0011828 -0.0578942 -0.0013546 -0.0836453 0.0579193 0.083656 0.0 +1309 2.95 3.15 93.75 0.0495663 0.0262723 -0.0495336 -0.0758505 -0.0265178 0.0758585 0.0 +1310 2.95 3.15 101.25 0.0825033 0.0923783 -0.0825646 -0.0624571 -0.0924447 0.0624949 0.0 +1311 2.95 3.15 108.75 0.0903024 0.12085 -0.0901393 -0.0395117 -0.120852 0.0395202 0.0 +1312 2.95 3.15 116.25 0.0638444 0.102339 -0.0638579 -0.00894728 -0.102235 0.00890468 0.0 +1313 2.95 3.15 123.75 0.0220461 0.0572511 -0.0219022 0.0169359 -0.0570113 -0.0169543 0.0 +1314 2.95 3.15 131.25 -0.015441 0.00943891 0.0156538 0.0325133 -0.00947592 -0.0324612 0.0 +1315 2.95 3.15 138.75 -0.0518112 -0.0403117 0.0516345 0.043965 0.0403656 -0.0440096 0.0 +1316 2.95 3.15 146.25 -0.104883 -0.106935 0.104923 0.0610883 0.106832 -0.0610049 0.0 +1317 2.95 3.15 153.75 -0.185793 -0.19961 0.185681 0.0885896 0.199403 -0.0885392 0.0 +1318 2.95 3.15 161.25 -0.283884 -0.306665 0.283899 0.123061 0.306488 -0.122974 0.0 +1319 2.95 3.15 168.75 -0.3736 -0.401945 0.373662 0.155182 0.401946 -0.155094 0.0 +1320 2.95 3.15 176.25 -0.427053 -0.458118 0.427085 0.174567 0.458223 -0.174634 0.0 +1321 2.95 3.25 3.75 -684.962 -33.597 684.962 11353.2 33.597 -11353.2 0.0 +1322 2.95 3.25 11.25 -400.069 -51.4433 400.069 4016.56 51.4433 -4016.56 0.0 +1323 2.95 3.25 18.75 -165.833 -38.5931 165.833 1203.1 38.5931 -1203.1 0.0 +1324 2.95 3.25 26.25 -47.263 -16.6148 47.263 276.987 16.6148 -276.987 0.0 +1325 2.95 3.25 33.75 -8.14408 -3.80756 8.14405 40.878 3.80754 -40.8779 0.0 +1326 2.95 3.25 41.25 -0.735673 -0.396549 0.73574 2.63773 0.396509 -2.63772 0.0 +1327 2.95 3.25 48.75 -0.150431 -0.333017 0.150544 0.0672603 0.332896 -0.0672187 0.0 +1328 2.95 3.25 56.25 -0.10876 -0.446971 0.10866 0.0972865 0.44696 -0.0973988 0.0 +1329 2.95 3.25 63.75 -0.118865 -0.37823 0.118992 0.0520019 0.378268 -0.052 0.0 +1330 2.95 3.25 71.25 -0.109895 -0.280626 0.109945 -0.000890606 0.280499 0.000905523 0.0 +1331 2.95 3.25 78.75 -0.0507365 -0.181073 0.0507334 -0.0461242 0.18097 0.0461348 0.0 +1332 2.95 3.25 86.25 -0.000734511 -0.0871476 0.00060714 -0.0555662 0.0872154 0.0555746 0.0 +1333 2.95 3.25 93.75 0.0311957 -0.00236195 -0.0311942 -0.0515041 0.00259597 0.0514843 0.0 +1334 2.95 3.25 101.25 0.0572093 0.0688848 -0.0571052 -0.0452318 -0.0687382 0.0452149 0.0 +1335 2.95 3.25 108.75 0.064287 0.106942 -0.0642778 -0.029198 -0.106939 0.0292002 0.0 +1336 2.95 3.25 116.25 0.0445212 0.10208 -0.0444717 -0.00721917 -0.102122 0.00721939 0.0 +1337 2.95 3.25 123.75 0.0135976 0.0703346 -0.0132914 0.0101515 -0.070214 -0.0102111 0.0 +1338 2.95 3.25 131.25 -0.0135575 0.0313234 0.0136726 0.0203596 -0.0316066 -0.0203055 0.0 +1339 2.95 3.25 138.75 -0.0393187 -0.0123616 0.0392606 0.0289017 0.0125322 -0.0289811 0.0 +1340 2.95 3.25 146.25 -0.0783219 -0.0713966 0.0781054 0.0422706 0.0716338 -0.0424701 0.0 +1341 2.95 3.25 153.75 -0.137718 -0.149787 0.137636 0.0630045 0.149918 -0.0630855 0.0 +1342 2.95 3.25 161.25 -0.209697 -0.23746 0.209832 0.0883427 0.237538 -0.0884379 0.0 +1343 2.95 3.25 168.75 -0.275371 -0.313873 0.275402 0.111664 0.314062 -0.111753 0.0 +1344 2.95 3.25 176.25 -0.314348 -0.358242 0.314391 0.125665 0.357993 -0.125515 0.0 +1345 2.95 3.35 3.75 -399.508 103.619 399.508 7451.41 -103.619 -7451.41 0.0 +1346 2.95 3.35 11.25 -231.405 35.127 231.405 3026.44 -35.127 -3026.44 0.0 +1347 2.95 3.35 18.75 -89.8146 -2.33149 89.8146 930.13 2.3315 -930.13 0.0 +1348 2.95 3.35 26.25 -22.0607 -7.1465 22.0607 211.828 7.14652 -211.828 0.0 +1349 2.95 3.35 33.75 -2.61211 -2.84669 2.61203 30.3988 2.84678 -30.3988 0.0 +1350 2.95 3.35 41.25 -0.0641668 -0.572722 0.0641482 1.85321 0.572769 -1.85319 0.0 +1351 2.95 3.35 48.75 -0.0727144 -0.324155 0.0726592 -0.0128306 0.324113 0.0128188 0.0 +1352 2.95 3.35 56.25 -0.0429539 -0.369477 0.0429431 0.0365148 0.369487 -0.0365382 0.0 +1353 2.95 3.35 63.75 -0.0600198 -0.322362 0.0600919 0.0327313 0.322318 -0.0327163 0.0 +1354 2.95 3.35 71.25 -0.0652833 -0.262303 0.0652719 -0.000945077 0.262315 0.000937457 0.0 +1355 2.95 3.35 78.75 -0.031022 -0.194374 0.0309769 -0.0267122 0.194554 0.0267582 0.0 +1356 2.95 3.35 86.25 -0.00184005 -0.113162 0.00176104 -0.0298197 0.113076 0.0298218 0.0 +1357 2.95 3.35 93.75 0.018586 -0.0277066 -0.0184827 -0.0312711 0.0276271 0.0312812 0.0 +1358 2.95 3.35 101.25 0.0371138 0.0478631 -0.037144 -0.0299553 -0.0480008 0.0299616 0.0 +1359 2.95 3.35 108.75 0.0423982 0.093388 -0.0422422 -0.0188882 -0.0933397 0.0188857 0.0 +1360 2.95 3.35 116.25 0.0273758 0.0979945 -0.0273687 -0.00448478 -0.0979721 0.00447213 0.0 +1361 2.95 3.35 123.75 0.00420771 0.0743592 -0.00427898 0.00600864 -0.0745728 -0.0058675 0.0 +1362 2.95 3.35 131.25 -0.0145851 0.0414175 0.0147362 0.0124371 -0.0414414 -0.0124358 0.0 +1363 2.95 3.35 138.75 -0.03007 0.00528296 0.0300369 0.0181261 -0.00525075 -0.018187 0.0 +1364 2.95 3.35 146.25 -0.0509356 -0.0404972 0.0512567 0.0264418 0.040464 -0.0264103 0.0 +1365 2.95 3.35 153.75 -0.0853645 -0.10106 0.0852954 0.0392425 0.100971 -0.0391701 0.0 +1366 2.95 3.35 161.25 -0.129326 -0.170331 0.12924 0.0554642 0.170326 -0.0554588 0.0 +1367 2.95 3.35 168.75 -0.171342 -0.232151 0.171081 0.0709676 0.232288 -0.0710617 0.0 +1368 2.95 3.35 176.25 -0.196671 -0.268622 0.196769 0.0804998 0.268617 -0.0804939 0.0 +1369 2.95 3.45 3.75 -118.47 124.094 118.47 3596.85 -124.094 -3596.85 0.0 +1370 2.95 3.45 11.25 -62.0251 58.1208 62.0251 1612.69 -58.1208 -1612.69 0.0 +1371 2.95 3.45 18.75 -17.2025 11.8124 17.2025 506.519 -11.8125 -506.519 0.0 +1372 2.95 3.45 26.25 -0.377844 -1.71658 0.37789 113.34 1.71654 -113.34 0.0 +1373 2.95 3.45 33.75 1.37632 -1.48954 -1.37633 15.5555 1.4896 -15.5555 0.0 +1374 2.95 3.45 41.25 0.265026 -0.272138 -0.265013 0.865629 0.272128 -0.865594 0.0 +1375 2.95 3.45 48.75 -0.0675124 -0.169675 0.0675642 -0.0146368 0.169647 0.0146363 0.0 +1376 2.95 3.45 56.25 -0.023388 -0.236641 0.0234179 0.015066 0.236607 -0.015018 0.0 +1377 2.95 3.45 63.75 -0.0206674 -0.214642 0.0205493 0.0137967 0.214624 -0.0137863 0.0 +1378 2.95 3.45 71.25 -0.0266153 -0.192791 0.0266153 -0.00202341 0.192818 0.00206841 0.0 +1379 2.95 3.45 78.75 -0.01303 -0.158177 0.0130391 -0.00963045 0.158217 0.00964696 0.0 +1380 2.95 3.45 86.25 -0.00222429 -0.0960735 0.0021395 -0.0105039 0.0961189 0.0105017 0.0 +1381 2.95 3.45 93.75 0.00366176 -0.0280042 -0.00362622 -0.0130186 0.0279556 0.0130227 0.0 +1382 2.95 3.45 101.25 0.0105055 0.0297138 -0.0104632 -0.0119289 -0.0296664 0.0119117 0.0 +1383 2.95 3.45 108.75 0.0148087 0.0656952 -0.0147408 -0.00665645 -0.0657398 0.0066868 0.0 +1384 2.95 3.45 116.25 0.0114932 0.0726041 -0.0116021 -0.00156607 -0.0726457 0.00154858 0.0 +1385 2.95 3.45 123.75 0.00309518 0.0572911 -0.00312058 0.00244903 -0.0572973 -0.00247607 0.0 +1386 2.95 3.45 131.25 -0.00423195 0.0348253 0.00428653 0.0058355 -0.0347892 -0.0058315 0.0 +1387 2.95 3.45 138.75 -0.00866474 0.0124609 0.00861874 0.00825108 -0.0125166 -0.00826851 0.0 +1388 2.95 3.45 146.25 -0.0145607 -0.0144555 0.0146647 0.0107256 0.0144883 -0.0106962 0.0 +1389 2.95 3.45 153.75 -0.0287837 -0.0532811 0.0286297 0.0157047 0.0531415 -0.0156193 0.0 +1390 2.95 3.45 161.25 -0.0515253 -0.102148 0.0515477 0.0240732 0.102183 -0.0241063 0.0 +1391 2.95 3.45 168.75 -0.0767337 -0.148935 0.0767439 0.0334601 0.1489 -0.0334712 0.0 +1392 2.95 3.45 176.25 -0.0932086 -0.17774 0.0931942 0.0396944 0.177763 -0.0397001 0.0 +1393 2.95 3.55 3.75 9.21891 55.9716 -9.21891 1053.07 -55.9716 -1053.07 0.0 +1394 2.95 3.55 11.25 12.0915 26.8507 -12.0915 505.759 -26.8507 -505.759 0.0 +1395 2.95 3.55 18.75 10.5932 5.25111 -10.5932 161.202 -5.25111 -161.202 0.0 +1396 2.95 3.55 26.25 5.832 -0.960922 -5.83198 35.2215 0.960912 -35.2215 0.0 +1397 2.95 3.55 33.75 1.90632 -0.606111 -1.90629 4.63776 0.606103 -4.63776 0.0 +1398 2.95 3.55 41.25 0.243995 0.00564805 -0.243998 0.296232 -0.00567539 -0.296199 0.0 +1399 2.95 3.55 48.75 -0.0591471 -0.00860415 0.0591375 0.0274887 0.00861739 -0.0274844 0.0 +1400 2.95 3.55 56.25 -0.0269926 -0.0691277 0.0269968 0.0114055 0.0691244 -0.0114149 0.0 +1401 2.95 3.55 63.75 -0.00607235 -0.0689444 0.00606736 0.00520628 0.0689476 -0.00519972 0.0 +1402 2.95 3.55 71.25 -0.00320545 -0.0714308 0.00319651 0.00162512 0.0714338 -0.00162543 0.0 +1403 2.95 3.55 78.75 -0.000709974 -0.0611886 0.00068591 -0.000332506 0.0611933 0.00033069 0.0 +1404 2.95 3.55 86.25 -0.00172169 -0.0350745 0.00168824 -0.00153632 0.035038 0.00153626 0.0 +1405 2.95 3.55 93.75 -0.00504304 -0.0114154 0.00501691 -0.001532 0.0114067 0.0015284 0.0 +1406 2.95 3.55 101.25 -0.00419399 0.00690274 0.00423812 -0.00070908 -0.00693605 0.000712363 0.0 +1407 2.95 3.55 108.75 0.00145246 0.0217666 -0.00146955 -0.00136473 -0.0217677 0.00136709 0.0 +1408 2.95 3.55 116.25 0.00646822 0.0283925 -0.00648991 -0.0023095 -0.0283929 0.00231683 0.0 +1409 2.95 3.55 123.75 0.0071676 0.0255024 -0.00717304 -0.00117394 -0.0255343 0.00118872 0.0 +1410 2.95 3.55 131.25 0.00551051 0.0191405 -0.00553503 0.000805702 -0.0191302 -0.000807014 0.0 +1411 2.95 3.55 138.75 0.00491972 0.0139924 -0.00492367 0.00107791 -0.0140157 -0.00107725 0.0 +1412 2.95 3.55 146.25 0.00468329 0.0079675 -0.00466349 9.16014e-06 -0.0079586 -7.70033e-06 0.0 +1413 2.95 3.55 153.75 0.00109992 -0.00389049 -0.00104878 0.000299902 0.00394253 -0.000326509 0.0 +1414 2.95 3.55 161.25 -0.0078958 -0.022461 0.00792024 0.0035239 0.0224411 -0.0035224 0.0 +1415 2.95 3.55 168.75 -0.019444 -0.0423078 0.0194506 0.00839838 0.0423256 -0.00840352 0.0 +1416 2.95 3.55 176.25 -0.0275442 -0.0551633 0.0275625 0.011971 0.0551683 -0.0119705 0.0 +1417 2.95 3.65 3.75 7.06704 4.57331 -7.06704 82.2836 -4.57331 -82.2836 0.0 +1418 2.95 3.65 11.25 5.4451 1.75617 -5.4451 41.4025 -1.75617 -41.4025 0.0 +1419 2.95 3.65 18.75 3.205 -0.181937 -3.205 13.315 0.181936 -13.315 0.0 +1420 2.95 3.65 26.25 1.3884 -0.45091 -1.3884 2.87287 0.450911 -2.87287 0.0 +1421 2.95 3.65 33.75 0.399535 -0.156162 -0.399534 0.408566 0.156164 -0.408568 0.0 +1422 2.95 3.65 41.25 0.0474327 0.000325414 -0.0474365 0.0559439 -0.000322232 -0.0559436 0.0 +1423 2.95 3.65 48.75 -0.0167623 0.0148239 0.0167622 0.0118571 -0.0148242 -0.011857 0.0 +1424 2.95 3.65 56.25 -0.00966538 0.00961204 0.00966566 0.000613902 -0.00961345 -0.000615629 0.0 +1425 2.95 3.65 63.75 -0.0018771 0.00670523 0.00187471 0.000440809 -0.00670146 -0.000440008 0.0 +1426 2.95 3.65 71.25 -0.000281351 0.00228719 0.000284629 0.00150972 -0.00228777 -0.00150899 0.0 +1427 2.95 3.65 78.75 -0.000573671 0.000786642 0.000576419 0.00114584 -0.000789663 -0.00114555 0.0 +1428 2.95 3.65 86.25 -0.00114618 0.000614687 0.00115016 0.000658531 -0.000610215 -0.000658224 0.0 +1429 2.95 3.65 93.75 -0.0014843 -0.00108906 0.00148416 0.000686066 0.00108644 -0.000685896 0.0 +1430 2.95 3.65 101.25 -0.000744824 -0.00226437 0.000742569 0.000394 0.00226277 -0.000394553 0.0 +1431 2.95 3.65 108.75 0.000733179 -0.00144773 -0.000733097 -0.000392875 0.00144773 0.000393178 0.0 +1432 2.95 3.65 116.25 0.00137293 -0.00049035 -0.00137606 -0.000632154 0.000487911 0.000633826 0.0 +1433 2.95 3.65 123.75 0.000493895 -0.000912215 -0.00049636 8.38473e-05 0.000900696 -7.85158e-05 0.0 +1434 2.95 3.65 131.25 -0.000825425 -0.0018564 0.000824058 0.000856545 0.00185558 -0.000856062 0.0 +1435 2.95 3.65 138.75 -0.00108814 -0.00180504 0.00109441 0.000819354 0.00179515 -0.000812508 0.0 +1436 2.95 3.65 146.25 1.93775e-05 -0.000479276 -1.65839e-05 0.000158438 0.000470583 -0.000154836 0.0 +1437 2.95 3.65 153.75 0.00166473 0.00127079 -0.00166242 -0.000315957 -0.00126902 0.00031561 0.0 +1438 2.95 3.65 161.25 0.00284097 0.00252966 -0.00283858 -0.000108367 -0.00252762 0.000107593 0.0 +1439 2.95 3.65 168.75 0.00323364 0.00305014 -0.00322845 0.000583253 -0.00304442 -0.000587227 0.0 +1440 2.95 3.65 176.25 0.00320119 0.00313431 -0.00320683 0.0011639 -0.00314025 -0.00116103 0.0 +1441 3.05 2.55 3.75 -99.8903 -1135.49 99.8903 4481.01 1135.49 -4481.01 0.0 +1442 3.05 2.55 11.25 75.4085 -849.863 -75.4085 2098.79 849.863 -2098.79 0.0 +1443 3.05 2.55 18.75 204.713 -503.811 -204.713 608.899 503.811 -608.899 0.0 +1444 3.05 2.55 26.25 215.712 -235.217 -215.712 55.4596 235.217 -55.4596 0.0 +1445 3.05 2.55 33.75 153.506 -77.04 -153.506 -60.3792 77.04 60.3792 0.0 +1446 3.05 2.55 41.25 82.3413 -6.02578 -82.3413 -46.2127 6.02578 46.2127 0.0 +1447 3.05 2.55 48.75 35.0888 15.3934 -35.0889 -22.0144 -15.3934 22.0144 0.0 +1448 3.05 2.55 56.25 12.4887 16.3495 -12.4887 -10.6162 -16.3495 10.6162 0.0 +1449 3.05 2.55 63.75 3.52861 12.5229 -3.52864 -7.32703 -12.5228 7.32705 0.0 +1450 3.05 2.55 71.25 -0.279629 9.40632 0.279539 -6.91201 -9.40632 6.91201 0.0 +1451 3.05 2.55 78.75 -2.43932 7.24433 2.43937 -6.84166 -7.24431 6.84167 0.0 +1452 3.05 2.55 86.25 -3.82544 5.01507 3.82548 -6.03456 -5.01503 6.03456 0.0 +1453 3.05 2.55 93.75 -4.46445 2.39183 4.46443 -4.45383 -2.39181 4.45382 0.0 +1454 3.05 2.55 101.25 -4.14103 -0.193617 4.14113 -2.7115 0.193643 2.7115 0.0 +1455 3.05 2.55 108.75 -2.68814 -2.24179 2.68814 -1.40298 2.24179 1.40298 0.0 +1456 3.05 2.55 116.25 -0.20595 -3.60299 0.205893 -0.720314 3.60292 0.720318 0.0 +1457 3.05 2.55 123.75 2.91287 -4.4257 -2.91292 -0.508612 4.42572 0.50859 0.0 +1458 3.05 2.55 131.25 6.14079 -4.94039 -6.14081 -0.503212 4.94043 0.503203 0.0 +1459 3.05 2.55 138.75 9.01174 -5.32326 -9.01176 -0.502488 5.32335 0.50246 0.0 +1460 3.05 2.55 146.25 11.2442 -5.66887 -11.2442 -0.418121 5.66881 0.418179 0.0 +1461 3.05 2.55 153.75 12.7662 -6.00759 -12.7662 -0.251267 6.00762 0.251242 0.0 +1462 3.05 2.55 161.25 13.6683 -6.32489 -13.6683 -0.0497353 6.3249 0.0497547 0.0 +1463 3.05 2.55 168.75 14.1224 -6.57903 -14.1224 0.126803 6.57893 -0.12674 0.0 +1464 3.05 2.55 176.25 14.2984 -6.72181 -14.2983 0.228789 6.72185 -0.228792 0.0 +1465 3.05 2.65 3.75 -471.72 -1123.11 471.72 7093.34 1123.11 -7093.34 0.0 +1466 3.05 2.65 11.25 -191.767 -808.934 191.767 3001.82 808.934 -3001.82 0.0 +1467 3.05 2.65 18.75 34.008 -459.915 -34.008 894.175 459.915 -894.175 0.0 +1468 3.05 2.65 26.25 112.955 -208.573 -112.955 151.189 208.573 -151.189 0.0 +1469 3.05 2.65 33.75 94.0738 -71.7327 -94.0737 -21.1677 71.7326 21.1677 0.0 +1470 3.05 2.65 41.25 49.4837 -14.5639 -49.4837 -25.8858 14.5639 25.8858 0.0 +1471 3.05 2.65 48.75 18.1201 2.71873 -18.1201 -10.7579 -2.71874 10.7579 0.0 +1472 3.05 2.65 56.25 4.50067 5.1919 -4.50071 -4.17437 -5.19187 4.17439 0.0 +1473 3.05 2.65 63.75 0.324738 4.12228 -0.324708 -2.7649 -4.12229 2.76489 0.0 +1474 3.05 2.65 71.25 -0.885083 3.14173 0.885105 -2.71919 -3.14167 2.71917 0.0 +1475 3.05 2.65 78.75 -1.47411 2.5775 1.47404 -2.75787 -2.57751 2.75787 0.0 +1476 3.05 2.65 86.25 -1.87152 1.90054 1.8715 -2.4228 -1.90059 2.4228 0.0 +1477 3.05 2.65 93.75 -2.02466 0.923135 2.02473 -1.71585 -0.923116 1.71585 0.0 +1478 3.05 2.65 101.25 -1.76347 -0.106789 1.76345 -0.967378 0.106801 0.967378 0.0 +1479 3.05 2.65 108.75 -0.963999 -0.917273 0.964072 -0.468617 0.917246 0.468634 0.0 +1480 3.05 2.65 116.25 0.320331 -1.45246 -0.320253 -0.271727 1.4525 0.271712 0.0 +1481 3.05 2.65 123.75 1.86745 -1.80964 -1.86754 -0.2599 1.80962 0.259901 0.0 +1482 3.05 2.65 131.25 3.39911 -2.09969 -3.3991 -0.291824 2.0997 0.291795 0.0 +1483 3.05 2.65 138.75 4.68845 -2.3866 -4.68845 -0.280717 2.38662 0.280678 0.0 +1484 3.05 2.65 146.25 5.61507 -2.69242 -5.61523 -0.201921 2.6924 0.201911 0.0 +1485 3.05 2.65 153.75 6.16957 -3.01207 -6.1696 -0.0714668 3.01198 0.0715084 0.0 +1486 3.05 2.65 161.25 6.42631 -3.31783 -6.42636 0.0757921 3.31775 -0.0757403 0.0 +1487 3.05 2.65 168.75 6.50157 -3.56436 -6.50164 0.201289 3.56437 -0.201315 0.0 +1488 3.05 2.65 176.25 6.50603 -3.70329 -6.50603 0.273064 3.70334 -0.273107 0.0 +1489 3.05 2.75 3.75 -819.915 -1054.18 819.915 10801.3 1054.18 -10801.3 0.0 +1490 3.05 2.75 11.25 -428.7 -725.593 428.7 3920.51 725.593 -3920.51 0.0 +1491 3.05 2.75 18.75 -114.05 -391.224 114.05 1152.33 391.224 -1152.33 0.0 +1492 3.05 2.75 26.25 26.6042 -166.507 -26.6042 231.532 166.507 -231.532 0.0 +1493 3.05 2.75 33.75 47.3 -54.4281 -47.3 8.52819 54.4281 -8.52819 0.0 +1494 3.05 2.75 41.25 26.4694 -12.5721 -26.4693 -12.454 12.5721 12.454 0.0 +1495 3.05 2.75 48.75 8.21568 -1.0587 -8.21571 -4.42962 1.05872 4.42958 0.0 +1496 3.05 2.75 56.25 0.933521 0.970656 -0.933436 -1.13308 -0.970672 1.13312 0.0 +1497 3.05 2.75 63.75 -0.591387 0.896497 0.591369 -0.802744 -0.896534 0.80272 0.0 +1498 3.05 2.75 71.25 -0.708852 0.736982 0.708892 -0.888009 -0.736903 0.888014 0.0 +1499 3.05 2.75 78.75 -0.726053 0.759715 0.726002 -0.940145 -0.759774 0.940141 0.0 +1500 3.05 2.75 86.25 -0.765586 0.712852 0.765659 -0.840917 -0.712822 0.840918 0.0 +1501 3.05 2.75 93.75 -0.763361 0.473034 0.763336 -0.584351 -0.473083 0.584352 0.0 +1502 3.05 2.75 101.25 -0.61589 0.159455 0.615896 -0.319598 -0.159469 0.319598 0.0 +1503 3.05 2.75 108.75 -0.25518 -0.0967453 0.255171 -0.166777 0.0969022 0.166722 0.0 +1504 3.05 2.75 116.25 0.285009 -0.28291 -0.284971 -0.126066 0.282912 0.126057 0.0 +1505 3.05 2.75 123.75 0.897522 -0.44854 -0.897517 -0.135093 0.448509 0.135108 0.0 +1506 3.05 2.75 131.25 1.46791 -0.62815 -1.46794 -0.139317 0.628143 0.139325 0.0 +1507 3.05 2.75 138.75 1.9137 -0.829458 -1.91378 -0.113487 0.829399 0.113499 0.0 +1508 3.05 2.75 146.25 2.19463 -1.05152 -2.19449 -0.0541464 1.05163 0.0541151 0.0 +1509 3.05 2.75 153.75 2.31281 -1.28912 -2.31287 0.0298665 1.2892 -0.0299121 0.0 +1510 3.05 2.75 161.25 2.31047 -1.52248 -2.31048 0.121875 1.52245 -0.121854 0.0 +1511 3.05 2.75 168.75 2.2526 -1.71516 -2.25253 0.200736 1.7151 -0.200722 0.0 +1512 3.05 2.75 176.25 2.20364 -1.82546 -2.20366 0.246345 1.82537 -0.246316 0.0 +1513 3.05 2.85 3.75 -1091.5 -924.826 1091.5 15876.4 924.826 -15876.4 0.0 +1514 3.05 2.85 11.25 -600.889 -610.446 600.889 4701.21 610.446 -4701.21 0.0 +1515 3.05 2.85 18.75 -221.774 -313.095 221.774 1347.46 313.095 -1347.46 0.0 +1516 3.05 2.85 26.25 -36.1715 -123.034 36.1715 288.867 123.034 -288.867 0.0 +1517 3.05 2.85 33.75 14.4109 -35.751 -14.4109 28.4156 35.751 -28.4156 0.0 +1518 3.05 2.85 41.25 11.7477 -7.54625 -11.7476 -4.47886 7.54624 4.47889 0.0 +1519 3.05 2.85 48.75 3.02266 -1.2724 -3.02262 -1.36059 1.27242 1.36062 0.0 +1520 3.05 2.85 56.25 -0.293101 -0.234224 0.293102 0.0148782 0.234259 -0.0148768 0.0 +1521 3.05 2.85 63.75 -0.604408 -0.0864725 0.604562 -0.135551 0.0865208 0.135542 0.0 +1522 3.05 2.85 71.25 -0.423986 -0.0183332 0.424026 -0.236452 0.0183536 0.236484 0.0 +1523 3.05 2.85 78.75 -0.3123 0.1248 0.312209 -0.277309 -0.124861 0.277305 0.0 +1524 3.05 2.85 86.25 -0.248721 0.239777 0.248749 -0.273132 -0.2399 0.273128 0.0 +1525 3.05 2.85 93.75 -0.199626 0.248962 0.199561 -0.204975 -0.24897 0.204973 0.0 +1526 3.05 2.85 101.25 -0.120259 0.201191 0.120215 -0.129864 -0.201248 0.129884 0.0 +1527 3.05 2.85 108.75 0.0123537 0.148079 -0.0122872 -0.0877108 -0.14809 0.0877165 0.0 +1528 3.05 2.85 116.25 0.173327 0.0836399 -0.173362 -0.0691073 -0.0836389 0.0691089 0.0 +1529 3.05 2.85 123.75 0.32621 -0.00777206 -0.326258 -0.0543665 0.00767605 0.054391 0.0 +1530 3.05 2.85 131.25 0.449831 -0.119322 -0.449959 -0.0354792 0.119322 0.0354522 0.0 +1531 3.05 2.85 138.75 0.531523 -0.239616 -0.531528 -0.0103697 0.239718 0.0103411 0.0 +1532 3.05 2.85 146.25 0.559126 -0.370369 -0.559031 0.0242302 0.370329 -0.0241818 0.0 +1533 3.05 2.85 153.75 0.528094 -0.517307 -0.52826 0.0705032 0.517171 -0.070455 0.0 +1534 3.05 2.85 161.25 0.453914 -0.672153 -0.453993 0.124135 0.672161 -0.124122 0.0 +1535 3.05 2.85 168.75 0.370253 -0.807261 -0.370135 0.173118 0.807245 -0.173108 0.0 +1536 3.05 2.85 176.25 0.315462 -0.887101 -0.315566 0.202652 0.887107 -0.202673 0.0 +1537 3.05 2.95 3.75 -1232.87 -727.611 1232.87 21705.2 727.611 -21705.2 0.0 +1538 3.05 2.95 11.25 -683.419 -470.91 683.419 5177.91 470.91 -5177.91 0.0 +1539 3.05 2.95 18.75 -278.179 -234.268 278.179 1452.23 234.268 -1452.23 0.0 +1540 3.05 2.95 26.25 -72.0176 -85.4621 72.0176 319.105 85.462 -319.105 0.0 +1541 3.05 2.95 33.75 -5.04395 -21.0669 5.04397 39.4173 21.0669 -39.4173 0.0 +1542 3.05 2.95 41.25 3.48774 -3.28191 -3.48769 -0.300635 3.2819 0.300647 0.0 +1543 3.05 2.95 48.75 0.664886 -0.652039 -0.664789 -0.139738 0.652028 0.139711 0.0 +1544 3.05 2.95 56.25 -0.523616 -0.414034 0.523516 0.306792 0.414075 -0.306796 0.0 +1545 3.05 2.95 63.75 -0.434262 -0.279203 0.434317 0.0328779 0.279155 -0.0328601 0.0 +1546 3.05 2.95 71.25 -0.263989 -0.17845 0.263927 -0.0557287 0.178451 0.0557149 0.0 +1547 3.05 2.95 78.75 -0.155524 -0.0604642 0.155421 -0.0950323 0.0604433 0.0950443 0.0 +1548 3.05 2.95 86.25 -0.067447 0.04758 0.0673218 -0.117252 -0.0475915 0.117248 0.0 +1549 3.05 2.95 93.75 -0.00166102 0.107279 0.00164027 -0.105172 -0.107316 0.105191 0.0 +1550 3.05 2.95 101.25 0.0535862 0.135458 -0.0536877 -0.0832458 -0.135274 0.0832323 0.0 +1551 3.05 2.95 108.75 0.0967651 0.14059 -0.0966865 -0.0609958 -0.14058 0.0609828 0.0 +1552 3.05 2.95 116.25 0.109945 0.110287 -0.109908 -0.0329892 -0.110348 0.033027 0.0 +1553 3.05 2.95 123.75 0.0929853 0.0494498 -0.0930526 -0.0025344 -0.0494806 0.00258764 0.0 +1554 3.05 2.95 131.25 0.0642303 -0.01905 -0.0641238 0.0216847 0.0188441 -0.0215685 0.0 +1555 3.05 2.95 138.75 0.0332905 -0.0834771 -0.0332997 0.03867 0.083467 -0.0386494 0.0 +1556 3.05 2.95 146.25 -0.00878391 -0.154233 0.00888735 0.0564103 0.154439 -0.0564727 0.0 +1557 3.05 2.95 153.75 -0.0746897 -0.245398 0.0746327 0.0831603 0.245496 -0.0832365 0.0 +1558 3.05 2.95 161.25 -0.160201 -0.353255 0.160227 0.119078 0.353605 -0.119288 0.0 +1559 3.05 2.95 168.75 -0.243403 -0.453661 0.243311 0.154918 0.453781 -0.154984 0.0 +1560 3.05 2.95 176.25 -0.294717 -0.514746 0.294773 0.177486 0.51451 -0.177287 0.0 +1561 3.05 3.05 3.75 -1202.39 -470.365 1202.39 24403 470.365 -24403 0.0 +1562 3.05 3.05 11.25 -668.169 -316.378 668.169 5239.8 316.378 -5239.8 0.0 +1563 3.05 3.05 18.75 -281.731 -159.304 281.731 1455.24 159.304 -1455.24 0.0 +1564 3.05 3.05 26.25 -82.2316 -55.9751 82.2316 322.339 55.9751 -322.339 0.0 +1565 3.05 3.05 33.75 -13.2072 -11.7376 13.2072 43.2474 11.7377 -43.2475 0.0 +1566 3.05 3.05 41.25 -0.23727 -0.951403 0.237225 1.56363 0.951413 -1.56361 0.0 +1567 3.05 3.05 48.75 -0.165939 -0.246228 0.165967 0.206541 0.24613 -0.206511 0.0 +1568 3.05 3.05 56.25 -0.436043 -0.410636 0.436083 0.304896 0.410632 -0.304963 0.0 +1569 3.05 3.05 63.75 -0.30763 -0.310295 0.307609 0.0679989 0.310281 -0.0680052 0.0 +1570 3.05 3.05 71.25 -0.206649 -0.205757 0.206684 -0.0143256 0.20578 0.0143312 0.0 +1571 3.05 3.05 78.75 -0.11617 -0.112842 0.116269 -0.0611922 0.112662 0.0611357 0.0 +1572 3.05 3.05 86.25 -0.029379 -0.026893 0.0293335 -0.0825493 0.0270606 0.0825471 0.0 +1573 3.05 3.05 93.75 0.0356369 0.0385347 -0.0355095 -0.077343 -0.0385093 0.0773448 0.0 +1574 3.05 3.05 101.25 0.0825754 0.0864857 -0.0826079 -0.0638125 -0.0866197 0.0638187 0.0 +1575 3.05 3.05 108.75 0.102049 0.105697 -0.102052 -0.0415323 -0.105879 0.0415234 0.0 +1576 3.05 3.05 116.25 0.0810613 0.0846985 -0.0811354 -0.00976694 -0.0847927 0.00982253 0.0 +1577 3.05 3.05 123.75 0.0328587 0.0382796 -0.0327086 0.0205591 -0.0383158 -0.0204996 0.0 +1578 3.05 3.05 131.25 -0.0175676 -0.00884341 0.0174819 0.0399706 0.00881225 -0.0399405 0.0 +1579 3.05 3.05 138.75 -0.0618523 -0.0507538 0.0617807 0.050519 0.0510671 -0.0507029 0.0 +1580 3.05 3.05 146.25 -0.112984 -0.102557 0.112876 0.062213 0.102547 -0.0622186 0.0 +1581 3.05 3.05 153.75 -0.183953 -0.177566 0.184157 0.0833769 0.177745 -0.0834765 0.0 +1582 3.05 3.05 161.25 -0.271208 -0.270479 0.271245 0.113891 0.27054 -0.113888 0.0 +1583 3.05 3.05 168.75 -0.353042 -0.357989 0.353053 0.145016 0.357905 -0.145054 0.0 +1584 3.05 3.05 176.25 -0.402759 -0.411064 0.402707 0.164734 0.411172 -0.164821 0.0 +1585 3.05 3.15 3.75 -1005.86 -194.498 1005.86 20622.3 194.498 -20622.3 0.0 +1586 3.05 3.15 11.25 -566.091 -160.869 566.091 4886.81 160.869 -4886.81 0.0 +1587 3.05 3.15 18.75 -240.287 -91.2699 240.287 1363.35 91.2699 -1363.35 0.0 +1588 3.05 3.15 26.25 -72.1732 -33.8748 72.1732 302.315 33.8748 -302.315 0.0 +1589 3.05 3.15 33.75 -13.3946 -6.76814 13.3946 41.8615 6.76815 -41.8615 0.0 +1590 3.05 3.15 41.25 -1.23842 -0.233142 1.2384 2.17485 0.233108 -2.17487 0.0 +1591 3.05 3.15 48.75 -0.292521 -0.178012 0.292534 0.218004 0.177961 -0.217937 0.0 +1592 3.05 3.15 56.25 -0.284809 -0.428332 0.284868 0.232091 0.428389 -0.232079 0.0 +1593 3.05 3.15 63.75 -0.220727 -0.340585 0.220826 0.0743496 0.340452 -0.0743638 0.0 +1594 3.05 3.15 71.25 -0.169662 -0.229028 0.169575 -0.00422416 0.228937 0.00423996 0.0 +1595 3.05 3.15 78.75 -0.0951492 -0.138864 0.0951079 -0.0524268 0.138897 0.0524133 0.0 +1596 3.05 3.15 86.25 -0.0249568 -0.057734 0.0249618 -0.0648182 0.0578461 0.0648357 0.0 +1597 3.05 3.15 93.75 0.0258392 0.0131362 -0.0256859 -0.0587348 -0.0128765 0.058722 0.0 +1598 3.05 3.15 101.25 0.0643498 0.0683206 -0.0643807 -0.0481836 -0.0685476 0.0481991 0.0 +1599 3.05 3.15 108.75 0.0794928 0.0928215 -0.0794856 -0.02838 -0.0927884 0.0283377 0.0 +1600 3.05 3.15 116.25 0.0621262 0.0783423 -0.0619376 -0.00193475 -0.0783081 0.00196418 0.0 +1601 3.05 3.15 123.75 0.0258006 0.041661 -0.0259602 0.0203971 -0.0415221 -0.0204713 0.0 +1602 3.05 3.15 131.25 -0.00984299 0.0033761 0.0098454 0.0334746 -0.00365493 -0.0333855 0.0 +1603 3.05 3.15 138.75 -0.0442769 -0.0350514 0.0443307 0.0414554 0.0352449 -0.041497 0.0 +1604 3.05 3.15 146.25 -0.091463 -0.0871559 0.0914155 0.052571 0.0871283 -0.0525267 0.0 +1605 3.05 3.15 153.75 -0.160353 -0.160828 0.160224 0.0723048 0.160761 -0.0723438 0.0 +1606 3.05 3.15 161.25 -0.243335 -0.247674 0.243164 0.0993507 0.247967 -0.0995663 0.0 +1607 3.05 3.15 168.75 -0.318898 -0.326134 0.319007 0.126072 0.32627 -0.126173 0.0 +1608 3.05 3.15 176.25 -0.36419 -0.372832 0.36427 0.142724 0.372732 -0.142595 0.0 +1609 3.05 3.25 3.75 -707.917 46.1555 707.917 14705.3 -46.1555 -14705.3 0.0 +1610 3.05 3.25 11.25 -403.239 -21.7092 403.239 4225.41 21.7092 -4225.41 0.0 +1611 3.05 3.25 18.75 -168.322 -33.4945 168.322 1198.15 33.4945 -1198.15 0.0 +1612 3.05 3.25 26.25 -49.4611 -17.619 49.4611 265.09 17.619 -265.09 0.0 +1613 3.05 3.25 33.75 -9.19503 -4.34197 9.19508 37.0193 4.34196 -37.0193 0.0 +1614 3.05 3.25 41.25 -0.984275 -0.283052 0.984305 2.13686 0.283053 -2.13689 0.0 +1615 3.05 3.25 48.75 -0.18842 -0.24192 0.188469 0.12944 0.241853 -0.129426 0.0 +1616 3.05 3.25 56.25 -0.14452 -0.42971 0.144635 0.148393 0.42977 -0.148431 0.0 +1617 3.05 3.25 63.75 -0.142141 -0.341575 0.142225 0.0603106 0.341607 -0.0603114 0.0 +1618 3.05 3.25 71.25 -0.120366 -0.235824 0.120331 -0.00584193 0.236031 0.00590595 0.0 +1619 3.05 3.25 78.75 -0.0648858 -0.155118 0.0648497 -0.0407089 0.155197 0.0406872 0.0 +1620 3.05 3.25 86.25 -0.0170367 -0.0778598 0.0169629 -0.0444295 0.0780579 0.0444343 0.0 +1621 3.05 3.25 93.75 0.0177195 -0.00503444 -0.0176269 -0.0424893 0.00514769 0.042496 0.0 +1622 3.05 3.25 101.25 0.0462891 0.05416 -0.0462865 -0.0373615 -0.0542229 0.0373631 0.0 +1623 3.05 3.25 108.75 0.0573669 0.084333 -0.0573216 -0.0224864 -0.0844456 0.0224838 0.0 +1624 3.05 3.25 116.25 0.0451776 0.0795648 -0.0451227 -0.00389795 -0.0795657 0.00392705 0.0 +1625 3.05 3.25 123.75 0.0215897 0.0526945 -0.021368 0.0103573 -0.0529347 -0.010223 0.0 +1626 3.05 3.25 131.25 -0.00169711 0.0202141 0.00167047 0.0191787 -0.0203379 -0.0191286 0.0 +1627 3.05 3.25 138.75 -0.0264021 -0.0159575 0.0263373 0.0263274 0.0160538 -0.0263645 0.0 +1628 3.05 3.25 146.25 -0.0639974 -0.0644796 0.063985 0.0366322 0.0642138 -0.0364741 0.0 +1629 3.05 3.25 153.75 -0.119886 -0.129575 0.119896 0.0530471 0.129703 -0.0531036 0.0 +1630 3.05 3.25 161.25 -0.186549 -0.203618 0.186351 0.0742664 0.20364 -0.0742798 0.0 +1631 3.05 3.25 168.75 -0.246276 -0.269152 0.246288 0.0946959 0.269294 -0.0948405 0.0 +1632 3.05 3.25 176.25 -0.281602 -0.307458 0.281688 0.107277 0.307531 -0.107285 0.0 +1633 3.05 3.35 3.75 -365.113 209.441 365.113 9554.04 -209.441 -9554.04 0.0 +1634 3.05 3.35 11.25 -204.246 81.0767 204.246 3280.1 -81.0766 -3280.1 0.0 +1635 3.05 3.35 18.75 -79.3542 9.6114 79.3542 951.267 -9.61141 -951.267 0.0 +1636 3.05 3.35 26.25 -20.8335 -5.94072 20.8335 209.249 5.9407 -209.249 0.0 +1637 3.05 3.35 33.75 -3.39742 -2.81825 3.39744 28.9771 2.81824 -28.9771 0.0 +1638 3.05 3.35 41.25 -0.403877 -0.37604 0.403872 1.67216 0.375997 -1.67217 0.0 +1639 3.05 3.35 48.75 -0.0863015 -0.268756 0.0862503 0.0304183 0.2687 -0.0303612 0.0 +1640 3.05 3.35 56.25 -0.0467076 -0.385723 0.0467254 0.0764897 0.385756 -0.0765678 0.0 +1641 3.05 3.35 63.75 -0.0765137 -0.296157 0.076492 0.0332949 0.296254 -0.033302 0.0 +1642 3.05 3.35 71.25 -0.0737102 -0.217777 0.0736319 -0.011919 0.217711 0.0118976 0.0 +1643 3.05 3.35 78.75 -0.0386226 -0.164005 0.0385937 -0.0252131 0.164091 0.0252167 0.0 +1644 3.05 3.35 86.25 -0.00860859 -0.0968502 0.00848829 -0.0245854 0.0969682 0.0245984 0.0 +1645 3.05 3.35 93.75 0.0147737 -0.0236231 -0.0147163 -0.0288229 0.0237517 0.0288162 0.0 +1646 3.05 3.35 101.25 0.0330742 0.0394288 -0.0329504 -0.0272844 -0.0394857 0.0273121 0.0 +1647 3.05 3.35 108.75 0.0377886 0.0770313 -0.0378089 -0.0166062 -0.0771797 0.0166531 0.0 +1648 3.05 3.35 116.25 0.0269164 0.0808568 -0.0269524 -0.00526022 -0.0808528 0.00523792 0.0 +1649 3.05 3.35 123.75 0.00994602 0.0605897 -0.00992017 0.00301009 -0.06072 -0.00291031 0.0 +1650 3.05 3.35 131.25 -0.00533206 0.0321631 0.00513532 0.00937287 -0.0322053 -0.00941624 0.0 +1651 3.05 3.35 138.75 -0.0198079 0.00170782 0.0198683 0.0152825 -0.00186433 -0.0152538 0.0 +1652 3.05 3.35 146.25 -0.0421542 -0.0369206 0.0421364 0.0228346 0.0366588 -0.0227076 0.0 +1653 3.05 3.35 153.75 -0.0772172 -0.0895244 0.0772434 0.0344402 0.0896002 -0.0344561 0.0 +1654 3.05 3.35 161.25 -0.121604 -0.151599 0.12161 0.0498996 0.151602 -0.0499331 0.0 +1655 3.05 3.35 168.75 -0.163376 -0.208149 0.163288 0.0652244 0.208133 -0.0652161 0.0 +1656 3.05 3.35 176.25 -0.188553 -0.242014 0.18862 0.0748184 0.241996 -0.0748296 0.0 +1657 3.05 3.45 3.75 -49.0063 211.636 49.0063 4534.02 -211.636 -4534.02 0.0 +1658 3.05 3.45 11.25 -16.2879 99.9048 16.2879 1783.56 -99.9048 -1783.56 0.0 +1659 3.05 3.45 18.75 1.92371 24.1588 -1.92369 528.913 -24.1588 -528.913 0.0 +1660 3.05 3.45 26.25 3.92081 0.239734 -3.92085 114.895 -0.239708 -114.895 0.0 +1661 3.05 3.45 33.75 1.33681 -1.29813 -1.33683 15.4468 1.29814 -15.4467 0.0 +1662 3.05 3.45 41.25 0.0515692 -0.168192 -0.0515773 0.808296 0.168187 -0.808324 0.0 +1663 3.05 3.45 48.75 -0.0454932 -0.172325 0.0455576 -0.0119284 0.172203 0.0119136 0.0 +1664 3.05 3.45 56.25 -0.00725921 -0.261217 0.00720111 0.0402311 0.261254 -0.040187 0.0 +1665 3.05 3.45 63.75 -0.0304125 -0.195611 0.0304302 0.0163773 0.195633 -0.0163835 0.0 +1666 3.05 3.45 71.25 -0.0332991 -0.159008 0.0333114 -0.00806962 0.159016 0.00804613 0.0 +1667 3.05 3.45 78.75 -0.0178735 -0.133654 0.0179131 -0.00824974 0.13361 0.00825353 0.0 +1668 3.05 3.45 86.25 -0.00502976 -0.0823886 0.00511234 -0.00794398 0.0823682 0.00794143 0.0 +1669 3.05 3.45 93.75 0.00414406 -0.0240697 -0.00419551 -0.0119802 0.0240974 0.0119811 0.0 +1670 3.05 3.45 101.25 0.0110567 0.0255518 -0.0111244 -0.0104323 -0.025573 0.0104402 0.0 +1671 3.05 3.45 108.75 0.0138462 0.0574772 -0.013883 -0.00606324 -0.0575893 0.00608259 0.0 +1672 3.05 3.45 116.25 0.011077 0.0635865 -0.0110606 -0.00305434 -0.0635874 0.00307944 0.0 +1673 3.05 3.45 123.75 0.00449426 0.0488256 -0.00448388 0.000439858 -0.0487677 -0.000429246 0.0 +1674 3.05 3.45 131.25 -0.0019067 0.0282409 0.0019165 0.0047807 -0.028183 -0.00479583 0.0 +1675 3.05 3.45 138.75 -0.00725526 0.00817585 0.0071253 0.00823976 -0.0082291 -0.00826636 0.0 +1676 3.05 3.45 146.25 -0.0164527 -0.017166 0.0163605 0.0119186 0.0170814 -0.0118721 0.0 +1677 3.05 3.45 153.75 -0.0355769 -0.0560084 0.0355731 0.0191433 0.0558956 -0.0190579 0.0 +1678 3.05 3.45 161.25 -0.0646594 -0.106219 0.0647645 0.0307881 0.106203 -0.0308022 0.0 +1679 3.05 3.45 168.75 -0.0953586 -0.154516 0.0954731 0.0434057 0.154565 -0.0434184 0.0 +1680 3.05 3.45 176.25 -0.115325 -0.184291 0.11528 0.0516029 0.184203 -0.0515372 0.0 +1681 3.05 3.55 3.75 58.2865 95.694 -58.2865 1303.18 -95.694 -1303.18 0.0 +1682 3.05 3.55 11.25 43.7842 47.0725 -43.7842 564.702 -47.0725 -564.702 0.0 +1683 3.05 3.55 18.75 24.1468 11.6001 -24.1468 170.104 -11.6002 -170.104 0.0 +1684 3.05 3.55 26.25 9.2032 0.165595 -9.2032 36.0656 -0.165608 -36.0656 0.0 +1685 3.05 3.55 33.75 2.10018 -0.495089 -2.10018 4.59251 0.495098 -4.5925 0.0 +1686 3.05 3.55 41.25 0.159888 0.0314295 -0.159875 0.213805 -0.0314347 -0.213825 0.0 +1687 3.05 3.55 48.75 -0.0316332 -0.0209589 0.0316297 0.0113881 0.020965 -0.011392 0.0 +1688 3.05 3.55 56.25 -0.00590874 -0.08247 0.00589294 0.029912 0.0824799 -0.0299018 0.0 +1689 3.05 3.55 63.75 -0.00460387 -0.0639712 0.00458972 0.0134455 0.0639916 -0.0134371 0.0 +1690 3.05 3.55 71.25 -0.00323754 -0.0605657 0.00327371 0.00123371 0.0605309 -0.00124148 0.0 +1691 3.05 3.55 78.75 -0.000975075 -0.0526099 0.000959984 0.00021812 0.052629 -0.000218025 0.0 +1692 3.05 3.55 86.25 -0.00152766 -0.0304211 0.00152531 -0.000124893 0.0304344 0.000128979 0.0 +1693 3.05 3.55 93.75 -0.00281045 -0.0103052 0.00282543 -0.000164696 0.0103138 0.000165631 0.0 +1694 3.05 3.55 101.25 -0.000794283 0.00655645 0.00082915 9.05452e-05 -0.0065146 -9.18973e-05 0.0 +1695 3.05 3.55 108.75 0.0048571 0.0208882 -0.00483972 -0.00172205 -0.020898 0.00171912 0.0 +1696 3.05 3.55 116.25 0.00910593 0.0261263 -0.00910381 -0.00286916 -0.026165 0.00289949 0.0 +1697 3.05 3.55 123.75 0.00835341 0.0213906 -0.00837047 -0.000577344 -0.0213633 0.000556754 0.0 +1698 3.05 3.55 131.25 0.00484672 0.0140179 -0.00483896 0.00261085 -0.0140112 -0.00259889 0.0 +1699 3.05 3.55 138.75 0.00145793 0.00803444 -0.00146708 0.00365082 -0.00802698 -0.00365445 0.0 +1700 3.05 3.55 146.25 -0.00319952 -0.000185068 0.00323208 0.00391313 0.000156672 -0.00387595 0.0 +1701 3.05 3.55 153.75 -0.0136071 -0.0160629 0.0136006 0.0069895 0.0160638 -0.00699597 0.0 +1702 3.05 3.55 161.25 -0.0307544 -0.0391932 0.0307909 0.0140586 0.0392269 -0.0140635 0.0 +1703 3.05 3.55 168.75 -0.0498663 -0.0628118 0.0498782 0.0225481 0.0628021 -0.0225421 0.0 +1704 3.05 3.55 176.25 -0.0625385 -0.0776921 0.0625437 0.0282624 0.0776849 -0.0282597 0.0 +1705 3.05 3.65 3.75 14.7738 9.01288 -14.7738 99.4234 -9.01288 -99.4234 0.0 +1706 3.05 3.65 11.25 10.4256 4.10096 -10.4256 45.9297 -4.10096 -45.9297 0.0 +1707 3.05 3.65 18.75 5.33829 0.564282 -5.33829 13.8766 -0.564281 -13.8766 0.0 +1708 3.05 3.65 26.25 1.92055 -0.318539 -1.92055 2.83407 0.318537 -2.83407 0.0 +1709 3.05 3.65 33.75 0.431842 -0.140656 -0.431843 0.348739 0.140656 -0.348739 0.0 +1710 3.05 3.65 41.25 0.0364247 0.00723669 -0.0364242 0.0264389 -0.00723644 -0.0264393 0.0 +1711 3.05 3.65 48.75 -0.0100345 0.0159315 0.0100318 0.0080024 -0.0159293 -0.00800035 0.0 +1712 3.05 3.65 56.25 -0.00452025 0.00778732 0.00451941 0.00551883 -0.00778686 -0.00552083 0.0 +1713 3.05 3.65 63.75 -0.000672337 0.00521555 0.000670408 0.00280248 -0.00521397 -0.00280318 0.0 +1714 3.05 3.65 71.25 0.000360923 0.00171355 -0.00036216 0.00121365 -0.00171269 -0.00121435 0.0 +1715 3.05 3.65 78.75 6.70805e-05 0.000819412 -6.59271e-05 0.000597606 -0.000817676 -0.000597435 0.0 +1716 3.05 3.65 86.25 -0.00057186 0.000644185 0.000572355 0.000567504 -0.00064307 -0.000567647 0.0 +1717 3.05 3.65 93.75 -0.000751471 -0.00106817 0.000749874 0.000757072 0.00106639 -0.000757055 0.0 +1718 3.05 3.65 101.25 0.000275919 -0.00183009 -0.000275096 0.000255174 0.00183474 -0.00025562 0.0 +1719 3.05 3.65 108.75 0.00189848 -0.000761837 -0.00189497 -0.000636546 0.000759074 0.000637236 0.0 +1720 3.05 3.65 116.25 0.00236351 -0.000115402 -0.00236272 -0.000553323 0.000119324 0.000553044 0.0 +1721 3.05 3.65 123.75 0.00106135 -0.00107726 -0.00106142 0.000592741 0.00108013 -0.000595129 0.0 +1722 3.05 3.65 131.25 -0.000675214 -0.0023987 0.000676951 0.00145629 0.00239971 -0.00145617 0.0 +1723 3.05 3.65 138.75 -0.00134281 -0.00270273 0.00134522 0.00120903 0.00269853 -0.00120659 0.0 +1724 3.05 3.65 146.25 -0.000900174 -0.00203273 0.000901187 0.000435489 0.00203583 -0.00043519 0.0 +1725 3.05 3.65 153.75 -0.000477871 -0.00132233 0.00047692 0.000219008 0.00131769 -0.000216421 0.0 +1726 3.05 3.65 161.25 -0.000970611 -0.00119912 0.000968838 0.000989395 0.00120357 -0.000993014 0.0 +1727 3.05 3.65 168.75 -0.00221265 -0.00158211 0.00221741 0.00227827 0.00158658 -0.00228145 0.0 +1728 3.05 3.65 176.25 -0.00325813 -0.00197769 0.00326165 0.00322864 0.00198236 -0.00323014 0.0 +1729 3.15 2.55 3.75 -27.4076 -1177.54 27.4076 2986.48 1177.54 -2986.48 0.0 +1730 3.15 2.55 11.25 114.909 -893.434 -114.909 1451.97 893.434 -1451.97 0.0 +1731 3.15 2.55 18.75 220.927 -531.426 -220.927 381.487 531.426 -381.487 0.0 +1732 3.15 2.55 26.25 220.034 -241.118 -220.034 -14.948 241.118 14.948 0.0 +1733 3.15 2.55 33.75 151.765 -67.0502 -151.765 -77.8707 67.0502 77.8707 0.0 +1734 3.15 2.55 41.25 77.6615 10.845 -77.6615 -49.9303 -10.845 49.9303 0.0 +1735 3.15 2.55 48.75 29.4755 32.5379 -29.4755 -24.2324 -32.5379 24.2323 0.0 +1736 3.15 2.55 56.25 7.15336 31.0306 -7.15333 -14.0732 -31.0306 14.0732 0.0 +1737 3.15 2.55 63.75 -1.05485 24.6005 1.05486 -12.17 -24.6005 12.17 0.0 +1738 3.15 2.55 71.25 -4.2524 19.4264 4.25245 -12.4357 -19.4264 12.4357 0.0 +1739 3.15 2.55 78.75 -6.26403 15.3863 6.26407 -11.9586 -15.3863 11.9586 0.0 +1740 3.15 2.55 86.25 -7.82419 11.1006 7.82418 -9.89676 -11.1007 9.89676 0.0 +1741 3.15 2.55 93.75 -8.44213 6.27427 8.44211 -6.88922 -6.27428 6.88922 0.0 +1742 3.15 2.55 101.25 -7.38509 1.54713 7.38513 -4.12212 -1.54706 4.12211 0.0 +1743 3.15 2.55 108.75 -4.32105 -2.46579 4.32104 -2.35334 2.46578 2.35333 0.0 +1744 3.15 2.55 116.25 0.406533 -5.63185 -0.406541 -1.60535 5.63179 1.60537 0.0 +1745 3.15 2.55 123.75 5.96181 -8.14327 -5.96181 -1.46219 8.14332 1.46217 0.0 +1746 3.15 2.55 131.25 11.4239 -10.2167 -11.4239 -1.47786 10.2167 1.47787 0.0 +1747 3.15 2.55 138.75 16.1105 -11.9601 -16.1106 -1.38993 11.9601 1.38992 0.0 +1748 3.15 2.55 146.25 19.6942 -13.3963 -19.6941 -1.1318 13.3963 1.13184 0.0 +1749 3.15 2.55 153.75 22.1564 -14.525 -22.1565 -0.756739 14.525 0.756719 0.0 +1750 3.15 2.55 161.25 23.6733 -15.3528 -23.6732 -0.361675 15.3528 0.361658 0.0 +1751 3.15 2.55 168.75 24.4933 -15.8939 -24.4933 -0.0403958 15.894 0.0403855 0.0 +1752 3.15 2.55 176.25 24.8391 -16.1612 -24.8391 0.138146 16.1611 -0.13812 0.0 +1753 3.15 2.65 3.75 -382.3 -1173.57 382.3 4819.79 1173.57 -4819.79 0.0 +1754 3.15 2.65 11.25 -147.278 -867.4 147.278 2217.25 867.401 -2217.25 0.0 +1755 3.15 2.65 18.75 53.0495 -503.218 -53.0495 646.011 503.218 -646.011 0.0 +1756 3.15 2.65 26.25 120.505 -229.082 -120.505 79.9388 229.082 -79.9388 0.0 +1757 3.15 2.65 33.75 95.7401 -74.5765 -95.7401 -36.4567 74.5765 36.4568 0.0 +1758 3.15 2.65 41.25 47.9555 -8.51743 -47.9555 -27.788 8.51743 27.788 0.0 +1759 3.15 2.65 48.75 15.3087 10.8882 -15.3087 -11.5215 -10.8882 11.5215 0.0 +1760 3.15 2.65 56.25 1.71235 12.3958 -1.71239 -5.88678 -12.3958 5.88679 0.0 +1761 3.15 2.65 63.75 -1.85784 9.95377 1.85788 -5.32284 -9.95375 5.32283 0.0 +1762 3.15 2.65 71.25 -2.5107 8.07183 2.51069 -5.66042 -8.0718 5.66043 0.0 +1763 3.15 2.65 78.75 -2.93298 6.81901 2.93306 -5.45184 -6.81897 5.45184 0.0 +1764 3.15 2.65 86.25 -3.48826 5.29061 3.48826 -4.3935 -5.29062 4.3935 0.0 +1765 3.15 2.65 93.75 -3.74316 3.25676 3.74317 -2.91544 -3.25679 2.91544 0.0 +1766 3.15 2.65 101.25 -3.14313 1.11525 3.14314 -1.68737 -1.11521 1.68737 0.0 +1767 3.15 2.65 108.75 -1.44888 -0.762392 1.44888 -1.05333 0.762401 1.05332 0.0 +1768 3.15 2.65 116.25 1.10632 -2.32234 -1.10636 -0.915764 2.32235 0.915769 0.0 +1769 3.15 2.65 123.75 3.999 -3.68327 -3.99905 -0.981961 3.68328 0.981933 0.0 +1770 3.15 2.65 131.25 6.71067 -4.9306 -6.71071 -1.01292 4.93052 1.01295 0.0 +1771 3.15 2.65 138.75 8.90941 -6.06124 -8.90948 -0.909875 6.06128 0.909848 0.0 +1772 3.15 2.65 146.25 10.478 -7.033 -10.478 -0.682663 7.03303 0.682641 0.0 +1773 3.15 2.65 153.75 11.4595 -7.81473 -11.4594 -0.390365 7.81474 0.390393 0.0 +1774 3.15 2.65 161.25 11.9866 -8.3981 -11.9866 -0.100784 8.39817 0.100743 0.0 +1775 3.15 2.65 168.75 12.2197 -8.78538 -12.2197 0.127706 8.78545 -0.127755 0.0 +1776 3.15 2.65 176.25 12.2968 -8.97894 -12.2968 0.253018 8.97893 -0.253004 0.0 +1777 3.15 2.75 3.75 -717.305 -1099.48 717.305 7349.12 1099.48 -7349.12 0.0 +1778 3.15 2.75 11.25 -384.145 -785.693 384.145 3043.13 785.693 -3043.13 0.0 +1779 3.15 2.75 18.75 -94.9682 -438.11 94.9682 898.217 438.11 -898.217 0.0 +1780 3.15 2.75 26.25 35.5855 -192.065 -35.5856 161.966 192.065 -161.966 0.0 +1781 3.15 2.75 33.75 51.0314 -63.115 -51.0314 -5.03306 63.115 5.03305 0.0 +1782 3.15 2.75 41.25 26.9766 -12.3012 -26.9766 -13.3863 12.3012 13.3863 0.0 +1783 3.15 2.75 48.75 7.19477 2.0083 -7.19476 -4.51753 -2.00835 4.51753 0.0 +1784 3.15 2.75 56.25 -0.300499 3.91871 0.300449 -1.9416 -3.91867 1.94161 0.0 +1785 3.15 2.75 63.75 -1.41191 3.2192 1.41193 -2.06438 -3.2192 2.06437 0.0 +1786 3.15 2.75 71.25 -1.09862 2.77961 1.09861 -2.31409 -2.77961 2.31408 0.0 +1787 3.15 2.75 78.75 -0.97934 2.69801 0.979376 -2.21566 -2.69799 2.21565 0.0 +1788 3.15 2.75 86.25 -1.14939 2.40786 1.14941 -1.73719 -2.40788 1.73719 0.0 +1789 3.15 2.75 93.75 -1.28476 1.7366 1.28478 -1.11459 -1.73658 1.11459 0.0 +1790 3.15 2.75 101.25 -1.02518 0.915603 1.02513 -0.67205 -0.915604 0.67204 0.0 +1791 3.15 2.75 108.75 -0.235222 0.152271 0.235251 -0.525599 -0.152295 0.52559 0.0 +1792 3.15 2.75 116.25 0.926335 -0.543285 -0.92633 -0.564825 0.54314 0.56486 0.0 +1793 3.15 2.75 123.75 2.16828 -1.23531 -2.16834 -0.624796 1.23529 0.624801 0.0 +1794 3.15 2.75 131.25 3.25208 -1.93488 -3.25213 -0.609967 1.93479 0.609996 0.0 +1795 3.15 2.75 138.75 4.06218 -2.59574 -4.06216 -0.506014 2.5958 0.506003 0.0 +1796 3.15 2.75 146.25 4.58223 -3.16844 -4.58219 -0.340482 3.16849 0.340441 0.0 +1797 3.15 2.75 153.75 4.85345 -3.63009 -4.85355 -0.150086 3.63016 0.150049 0.0 +1798 3.15 2.75 161.25 4.94755 -3.97851 -4.9476 0.031051 3.97843 -0.0310191 0.0 +1799 3.15 2.75 168.75 4.94687 -4.2147 -4.94688 0.172789 4.21474 -0.172809 0.0 +1800 3.15 2.75 176.25 4.92478 -4.33518 -4.92479 0.250736 4.33503 -0.250683 0.0 +1801 3.15 2.85 3.75 -983.407 -958.469 983.407 10771.7 958.469 -10771.7 0.0 +1802 3.15 2.85 11.25 -561.262 -663.174 561.262 3820.65 663.174 -3820.65 0.0 +1803 3.15 2.85 18.75 -205.213 -355.243 205.213 1105.74 355.243 -1105.74 0.0 +1804 3.15 2.85 26.25 -27.6167 -147.063 27.6167 223.87 147.063 -223.87 0.0 +1805 3.15 2.85 33.75 18.7771 -45.3665 -18.7771 16.2432 45.3665 -16.2432 0.0 +1806 3.15 2.85 41.25 13.1994 -9.43272 -13.1993 -5.05834 9.43266 5.05833 0.0 +1807 3.15 2.85 48.75 2.91908 -0.530057 -2.9191 -1.2319 0.530074 1.23189 0.0 +1808 3.15 2.85 56.25 -0.745478 0.739328 0.745498 -0.367498 -0.73929 0.367529 0.0 +1809 3.15 2.85 63.75 -0.81633 0.642883 0.816313 -0.716454 -0.6429 0.716445 0.0 +1810 3.15 2.85 71.25 -0.349638 0.675056 0.349664 -0.850932 -0.675061 0.850935 0.0 +1811 3.15 2.85 78.75 -0.149673 0.893423 0.149656 -0.801893 -0.893408 0.80189 0.0 +1812 3.15 2.85 86.25 -0.178712 0.982033 0.178685 -0.62163 -0.982034 0.621621 0.0 +1813 3.15 2.85 93.75 -0.242997 0.836119 0.242971 -0.408167 -0.836147 0.408172 0.0 +1814 3.15 2.85 101.25 -0.148846 0.585948 0.148786 -0.292887 -0.586035 0.292911 0.0 +1815 3.15 2.85 108.75 0.15606 0.331721 -0.155971 -0.293195 -0.331795 0.293195 0.0 +1816 3.15 2.85 116.25 0.567422 0.0594929 -0.567484 -0.331987 -0.0594022 0.331944 0.0 +1817 3.15 2.85 123.75 0.950702 -0.26038 -0.950731 -0.339941 0.260353 0.33994 0.0 +1818 3.15 2.85 131.25 1.23582 -0.606832 -1.23578 -0.298798 0.60675 0.298849 0.0 +1819 3.15 2.85 138.75 1.41461 -0.932834 -1.4147 -0.222025 0.932801 0.222074 0.0 +1820 3.15 2.85 146.25 1.50107 -1.20911 -1.50116 -0.126578 1.20906 0.1266 0.0 +1821 3.15 2.85 153.75 1.51127 -1.43277 -1.51127 -0.0238121 1.43294 0.0237802 0.0 +1822 3.15 2.85 161.25 1.46794 -1.61001 -1.46801 0.0755362 1.60995 -0.0755328 0.0 +1823 3.15 2.85 168.75 1.40576 -1.73855 -1.40577 0.156592 1.73865 -0.156591 0.0 +1824 3.15 2.85 176.25 1.36216 -1.80797 -1.36229 0.202726 1.80777 -0.202612 0.0 +1825 3.15 2.95 3.75 -1133.1 -747.847 1133.1 15204 747.847 -15204 0.0 +1826 3.15 2.95 11.25 -651.39 -510.215 651.39 4410.35 510.215 -4410.35 0.0 +1827 3.15 2.95 18.75 -265.384 -267.084 265.384 1240.36 267.084 -1240.36 0.0 +1828 3.15 2.95 26.25 -65.2059 -104.595 65.2059 261.401 104.595 -261.401 0.0 +1829 3.15 2.95 33.75 -1.1926 -29.0236 1.19257 28.5192 29.0237 -28.5193 0.0 +1830 3.15 2.95 41.25 5.04407 -5.31881 -5.04405 -0.879049 5.31877 0.879106 0.0 +1831 3.15 2.95 48.75 0.8753 -0.662049 -0.875315 -0.00872159 0.662128 0.00871009 0.0 +1832 3.15 2.95 56.25 -0.675197 -0.139671 0.675175 0.120631 0.13964 -0.120625 0.0 +1833 3.15 2.95 63.75 -0.46544 -0.0874773 0.465367 -0.212443 0.0874908 0.212434 0.0 +1834 3.15 2.95 71.25 -0.134062 0.0228327 0.133943 -0.278094 -0.0228418 0.278081 0.0 +1835 3.15 2.95 78.75 0.0168447 0.202657 -0.0168125 -0.266574 -0.202643 0.266593 0.0 +1836 3.15 2.95 86.25 0.0503193 0.315249 -0.0504007 -0.219306 -0.315241 0.219299 0.0 +1837 3.15 2.95 93.75 0.0502706 0.316426 -0.050226 -0.163651 -0.316425 0.163654 0.0 +1838 3.15 2.95 101.25 0.0985225 0.273347 -0.0985613 -0.146427 -0.273435 0.146416 0.0 +1839 3.15 2.95 108.75 0.199999 0.219778 -0.200098 -0.158023 -0.219778 0.157999 0.0 +1840 3.15 2.95 116.25 0.291735 0.132266 -0.291722 -0.160235 -0.132314 0.160262 0.0 +1841 3.15 2.95 123.75 0.329285 0.00185382 -0.329175 -0.137448 -0.00180331 0.13745 0.0 +1842 3.15 2.95 131.25 0.321385 -0.143622 -0.32142 -0.0993839 0.143295 0.0995188 0.0 +1843 3.15 2.95 138.75 0.294709 -0.273448 -0.294757 -0.0582161 0.273501 0.0581947 0.0 +1844 3.15 2.95 146.25 0.258238 -0.381886 -0.258155 -0.0155935 0.381841 0.0156253 0.0 +1845 3.15 2.95 153.75 0.205735 -0.479784 -0.205679 0.0327166 0.479841 -0.0327496 0.0 +1846 3.15 2.95 161.25 0.136947 -0.573355 -0.136947 0.0862248 0.573448 -0.0862026 0.0 +1847 3.15 2.95 168.75 0.0680279 -0.653564 -0.0680505 0.135147 0.653578 -0.135158 0.0 +1848 3.15 2.95 176.25 0.0243153 -0.701137 -0.024347 0.164886 0.701089 -0.164896 0.0 +1849 3.15 3.05 3.75 -1128.81 -471.423 1128.81 19895.2 471.423 -19895.2 0.0 +1850 3.15 3.05 11.25 -641.984 -337.183 641.984 4682.14 337.183 -4682.14 0.0 +1851 3.15 3.05 18.75 -271.929 -180.723 271.929 1285.25 180.723 -1285.25 0.0 +1852 3.15 3.05 26.25 -77.5442 -69.2222 77.5442 273.985 69.2222 -273.985 0.0 +1853 3.15 3.05 33.75 -10.5076 -17.2305 10.5076 33.7556 17.2305 -33.7556 0.0 +1854 3.15 3.05 41.25 0.942208 -2.36919 -0.94215 0.890868 2.36915 -0.890877 0.0 +1855 3.15 3.05 48.75 0.0413467 -0.341702 -0.0413853 0.284244 0.341717 -0.284258 0.0 +1856 3.15 3.05 56.25 -0.512539 -0.300118 0.512514 0.221017 0.300055 -0.221053 0.0 +1857 3.15 3.05 63.75 -0.326838 -0.225898 0.326884 -0.0197921 0.225764 0.019847 0.0 +1858 3.15 3.05 71.25 -0.151039 -0.130692 0.151122 -0.0702483 0.130597 0.0702255 0.0 +1859 3.15 3.05 78.75 -0.0510117 -0.0313348 0.0509675 -0.0903598 0.0314037 0.0903852 0.0 +1860 3.15 3.05 86.25 0.0100222 0.0417384 -0.00996435 -0.0903162 -0.0416107 0.090323 0.0 +1861 3.15 3.05 93.75 0.0505204 0.0773802 -0.050533 -0.0784695 -0.0774641 0.0784768 0.0 +1862 3.15 3.05 101.25 0.0974621 0.100727 -0.0974267 -0.0743341 -0.100721 0.0743344 0.0 +1863 3.15 3.05 108.75 0.138649 0.111398 -0.138664 -0.0691871 -0.111313 0.06919 0.0 +1864 3.15 3.05 116.25 0.139119 0.0890717 -0.139004 -0.0513441 -0.089038 0.0513577 0.0 +1865 3.15 3.05 123.75 0.0947612 0.0372026 -0.0948916 -0.0254731 -0.0372875 0.0254522 0.0 +1866 3.15 3.05 131.25 0.0352216 -0.0199093 -0.0352501 -0.0029018 0.0197286 0.003042 0.0 +1867 3.15 3.05 138.75 -0.0170544 -0.0691083 0.0169796 0.0128318 0.0690801 -0.0128405 0.0 +1868 3.15 3.05 146.25 -0.0650118 -0.117582 0.0649726 0.0284301 0.117519 -0.0283881 0.0 +1869 3.15 3.05 153.75 -0.123114 -0.17842 0.123091 0.0525561 0.178429 -0.0526076 0.0 +1870 3.15 3.05 161.25 -0.194145 -0.252323 0.194335 0.0863865 0.252507 -0.0864426 0.0 +1871 3.15 3.05 168.75 -0.263497 -0.323299 0.263507 0.121102 0.323227 -0.121095 0.0 +1872 3.15 3.05 176.25 -0.306581 -0.367138 0.306588 0.143278 0.367034 -0.143215 0.0 +1873 3.15 3.15 3.75 -956.411 -157.961 956.411 21490.2 157.961 -21490.2 0.0 +1874 3.15 3.15 11.25 -539.133 -158.376 539.133 4570.6 158.376 -4570.6 0.0 +1875 3.15 3.15 18.75 -230.746 -100.448 230.746 1239.08 100.448 -1239.08 0.0 +1876 3.15 3.15 26.25 -69.0286 -41.453 69.0285 264.322 41.4531 -264.322 0.0 +1877 3.15 3.15 33.75 -11.9443 -9.95787 11.9443 34.0693 9.95793 -34.0693 0.0 +1878 3.15 3.15 41.25 -0.582646 -0.953585 0.58261 1.49815 0.953585 -1.49815 0.0 +1879 3.15 3.15 48.75 -0.185725 -0.189058 0.185672 0.262739 0.188971 -0.262688 0.0 +1880 3.15 3.15 56.25 -0.35028 -0.339487 0.350287 0.209512 0.33955 -0.209522 0.0 +1881 3.15 3.15 63.75 -0.251984 -0.259721 0.252092 0.053384 0.25962 -0.0533321 0.0 +1882 3.15 3.15 71.25 -0.171035 -0.17401 0.170979 -0.00382131 0.173971 0.003789 0.0 +1883 3.15 3.15 78.75 -0.103081 -0.108356 0.103106 -0.0377398 0.108153 0.0377189 0.0 +1884 3.15 3.15 86.25 -0.0427632 -0.046394 0.0427713 -0.0466376 0.0463966 0.046639 0.0 +1885 3.15 3.15 93.75 0.00566927 0.00495154 -0.00569908 -0.0428492 -0.00499621 0.0428512 0.0 +1886 3.15 3.15 101.25 0.0504745 0.0463917 -0.0505543 -0.0360707 -0.0464682 0.0360915 0.0 +1887 3.15 3.15 108.75 0.0794281 0.0686813 -0.0795551 -0.0228925 -0.0688457 0.0229235 0.0 +1888 3.15 3.15 116.25 0.0742594 0.061464 -0.0741882 -0.00450275 -0.0615471 0.00449575 0.0 +1889 3.15 3.15 123.75 0.0412054 0.0335455 -0.0410459 0.0122873 -0.0334909 -0.0122658 0.0 +1890 3.15 3.15 131.25 0.00256192 0.00204886 -0.00232937 0.0225283 -0.00204045 -0.0224878 0.0 +1891 3.15 3.15 138.75 -0.0317873 -0.0281822 0.0319935 0.0275685 0.0282669 -0.0275469 0.0 +1892 3.15 3.15 146.25 -0.0711984 -0.0672197 0.0711102 0.0343857 0.0670901 -0.0343675 0.0 +1893 3.15 3.15 153.75 -0.126399 -0.123952 0.126399 0.0498039 0.123889 -0.049802 0.0 +1894 3.15 3.15 161.25 -0.195704 -0.194707 0.195608 0.074158 0.194762 -0.0742025 0.0 +1895 3.15 3.15 168.75 -0.261579 -0.261942 0.261393 0.100026 0.261901 -0.100036 0.0 +1896 3.15 3.15 176.25 -0.301524 -0.302836 0.301604 0.116713 0.302746 -0.116682 0.0 +1897 3.15 3.25 3.75 -650.193 134.226 650.193 17650.1 -134.226 -17650.1 0.0 +1898 3.15 3.25 11.25 -365.979 7.48146 365.979 4109.37 -7.48145 -4109.37 0.0 +1899 3.15 3.25 18.75 -155.208 -30.119 155.208 1115.3 30.119 -1115.3 0.0 +1900 3.15 3.25 26.25 -46.6783 -20.0797 46.6784 237.228 20.0796 -237.228 0.0 +1901 3.15 3.25 33.75 -8.72374 -5.70064 8.7238 31.186 5.70056 -31.186 0.0 +1902 3.15 3.25 41.25 -0.780005 -0.490403 0.779991 1.61053 0.490338 -1.61049 0.0 +1903 3.15 3.25 48.75 -0.160056 -0.188506 0.160035 0.172817 0.188447 -0.172832 0.0 +1904 3.15 3.25 56.25 -0.197253 -0.356173 0.197337 0.156424 0.35612 -0.156432 0.0 +1905 3.15 3.25 63.75 -0.16741 -0.265816 0.167365 0.0571964 0.265815 -0.0571946 0.0 +1906 3.15 3.25 71.25 -0.130237 -0.184874 0.130267 0.00234427 0.184786 -0.0023759 0.0 +1907 3.15 3.25 78.75 -0.0843061 -0.129234 0.0843542 -0.022381 0.129426 0.0223457 0.0 +1908 3.15 3.25 86.25 -0.03979 -0.0657959 0.0398035 -0.0277737 0.0658759 0.0277741 0.0 +1909 3.15 3.25 93.75 -0.00238909 -0.00774928 0.00240125 -0.0282358 0.00785304 0.028235 0.0 +1910 3.15 3.25 101.25 0.0303823 0.0357636 -0.0303854 -0.0222829 -0.0356794 0.0222854 0.0 +1911 3.15 3.25 108.75 0.0506977 0.0585556 -0.0506894 -0.0102554 -0.0584086 0.0102105 0.0 +1912 3.15 3.25 116.25 0.0502104 0.0558613 -0.050186 0.00160465 -0.0559321 -0.00157822 0.0 +1913 3.15 3.25 123.75 0.0345455 0.035523 -0.0344902 0.0104005 -0.0355763 -0.0103987 0.0 +1914 3.15 3.25 131.25 0.0151486 0.0110531 -0.015251 0.0158941 -0.0112994 -0.0157901 0.0 +1915 3.15 3.25 138.75 -0.0050971 -0.013565 0.00511178 0.019016 0.013684 -0.0190174 0.0 +1916 3.15 3.25 146.25 -0.0345021 -0.0459216 0.0345176 0.0233695 0.0459787 -0.0233686 0.0 +1917 3.15 3.25 153.75 -0.0793413 -0.0928252 0.079314 0.0332493 0.092565 -0.033146 0.0 +1918 3.15 3.25 161.25 -0.134603 -0.150218 0.13452 0.0491025 0.150129 -0.0490542 0.0 +1919 3.15 3.25 168.75 -0.18553 -0.204163 0.185623 0.0660649 0.204474 -0.0662343 0.0 +1920 3.15 3.25 176.25 -0.216402 -0.237045 0.216252 0.0770174 0.237253 -0.0771667 0.0 +1921 3.15 3.35 3.75 -275.127 338.879 275.127 11754.8 -338.879 -11754.8 0.0 +1922 3.15 3.35 11.25 -149.928 134.982 149.928 3283.86 -134.982 -3283.86 0.0 +1923 3.15 3.35 18.75 -59.9126 24.6097 59.9126 901.613 -24.6098 -901.613 0.0 +1924 3.15 3.35 26.25 -17.3899 -3.93464 17.3899 190.736 3.93463 -190.736 0.0 +1925 3.15 3.35 33.75 -3.54567 -2.80737 3.54565 25.2257 2.80735 -25.2256 0.0 +1926 3.15 3.35 41.25 -0.5028 -0.297045 0.502764 1.39094 0.297079 -1.39098 0.0 +1927 3.15 3.35 48.75 -0.0786613 -0.21351 0.0785848 0.0781363 0.213592 -0.0781848 0.0 +1928 3.15 3.35 56.25 -0.0749822 -0.340141 0.0749439 0.0885512 0.340151 -0.0884967 0.0 +1929 3.15 3.35 63.75 -0.0903085 -0.233796 0.0902789 0.0251462 0.233735 -0.0251422 0.0 +1930 3.15 3.35 71.25 -0.0742191 -0.168217 0.0742917 -0.0123034 0.168118 0.0122774 0.0 +1931 3.15 3.35 78.75 -0.0442502 -0.131009 0.0441129 -0.0159319 0.131038 0.0159283 0.0 +1932 3.15 3.35 86.25 -0.0140131 -0.074057 0.0140325 -0.0175558 0.0741452 0.0175633 0.0 +1933 3.15 3.35 93.75 0.0107044 -0.016984 -0.0107096 -0.0224514 0.0169392 0.0224516 0.0 +1934 3.15 3.35 101.25 0.0273468 0.0283944 -0.0273571 -0.0182899 -0.0285471 0.0182767 0.0 +1935 3.15 3.35 108.75 0.0341621 0.05763 -0.0342268 -0.00978414 -0.0577058 0.00979257 0.0 +1936 3.15 3.35 116.25 0.0303908 0.0623219 -0.030319 -0.00386081 -0.0623156 0.00386282 0.0 +1937 3.15 3.35 123.75 0.0193498 0.0473473 -0.0192958 0.00117491 -0.0471971 -0.0012989 0.0 +1938 3.15 3.35 131.25 0.00780853 0.0276758 -0.00776157 0.00608841 -0.0275645 -0.00615459 0.0 +1939 3.15 3.35 138.75 -0.00281951 0.00980171 0.0028173 0.00899561 -0.0103754 -0.00875617 0.0 +1940 3.15 3.35 146.25 -0.0177849 -0.0122083 0.0178591 0.0111587 0.0120863 -0.0110729 0.0 +1941 3.15 3.35 153.75 -0.0428755 -0.0468128 0.0427986 0.0164875 0.0467219 -0.0164577 0.0 +1942 3.15 3.35 161.25 -0.0757418 -0.0922436 0.0757394 0.0263114 0.0922185 -0.0263166 0.0 +1943 3.15 3.35 168.75 -0.107642 -0.136426 0.107584 0.0374315 0.136228 -0.0373364 0.0 +1944 3.15 3.35 176.25 -0.127132 -0.16362 0.127062 0.0447389 0.163558 -0.0447096 0.0 +1945 3.15 3.45 3.75 46.6657 326.302 -46.6657 5480.32 -326.302 -5480.32 0.0 +1946 3.15 3.45 11.25 39.3764 154.267 -39.3764 1815.17 -154.267 -1815.17 0.0 +1947 3.15 3.45 18.75 22.0244 42.3138 -22.0244 505.91 -42.3138 -505.91 0.0 +1948 3.15 3.45 26.25 7.29371 4.3406 -7.29372 105.668 -4.3406 -105.668 0.0 +1949 3.15 3.45 33.75 0.914334 -0.603679 -0.914334 13.7287 0.603677 -13.7287 0.0 +1950 3.15 3.45 41.25 -0.158065 -0.0326246 0.158056 0.711344 0.0326778 -0.711315 0.0 +1951 3.15 3.45 48.75 -0.0159738 -0.166204 0.0159671 0.0133403 0.16615 -0.0133219 0.0 +1952 3.15 3.45 56.25 -0.00488119 -0.253233 0.00491148 0.0471634 0.253244 -0.0471562 0.0 +1953 3.15 3.45 63.75 -0.0387289 -0.159738 0.0387929 0.00737726 0.159718 -0.00733701 0.0 +1954 3.15 3.45 71.25 -0.0342167 -0.123108 0.0342095 -0.0134089 0.123119 0.0133794 0.0 +1955 3.15 3.45 78.75 -0.0183889 -0.107233 0.0183971 -0.00702141 0.10719 0.00700092 0.0 +1956 3.15 3.45 86.25 -0.00224304 -0.0672358 0.00223149 -0.00740458 0.06732 0.00740179 0.0 +1957 3.15 3.45 93.75 0.00883338 -0.0235886 -0.00886164 -0.0107045 0.0235433 0.0107089 0.0 +1958 3.15 3.45 101.25 0.0123235 0.015828 -0.012348 -0.00762384 -0.0158064 0.00760398 0.0 +1959 3.15 3.45 108.75 0.0118714 0.0452165 -0.0118843 -0.00509858 -0.0451645 0.00505638 0.0 +1960 3.15 3.45 116.25 0.00859034 0.0531575 -0.00865278 -0.00443542 -0.0532255 0.00444204 0.0 +1961 3.15 3.45 123.75 0.00258788 0.0423716 -0.00256692 -0.00117868 -0.0424366 0.00121603 0.0 +1962 3.15 3.45 131.25 -0.00267606 0.0273421 0.00253797 0.00313079 -0.0273467 -0.00313102 0.0 +1963 3.15 3.45 138.75 -0.00458018 0.0145732 0.00460276 0.00490419 -0.0145389 -0.00492224 0.0 +1964 3.15 3.45 146.25 -0.00839922 -0.00315912 0.00836753 0.00593978 0.00307101 -0.00589991 0.0 +1965 3.15 3.45 153.75 -0.0209444 -0.0338477 0.020904 0.0108714 0.0337667 -0.0108179 0.0 +1966 3.15 3.45 161.25 -0.0433497 -0.0756648 0.043318 0.020838 0.0757092 -0.0208768 0.0 +1967 3.15 3.45 168.75 -0.0683875 -0.116448 0.0683041 0.0321496 0.116416 -0.0321632 0.0 +1968 3.15 3.45 176.25 -0.0847651 -0.141502 0.0847114 0.0395279 0.141475 -0.0394984 0.0 +1969 3.15 3.55 3.75 113.453 150.898 -113.453 1527.06 -150.898 -1527.06 0.0 +1970 3.15 3.55 11.25 75.6979 75.7027 -75.6979 574.861 -75.7027 -574.861 0.0 +1971 3.15 3.55 18.75 35.5664 22.022 -35.5664 161.502 -22.022 -161.502 0.0 +1972 3.15 3.55 26.25 10.941 2.87256 -10.941 32.6315 -2.87256 -32.6315 0.0 +1973 3.15 3.55 33.75 1.72278 0.0375193 -1.7228 3.93133 -0.0374953 -3.93134 0.0 +1974 3.15 3.55 41.25 0.0142898 0.108618 -0.0143047 0.136579 -0.108608 -0.136591 0.0 +1975 3.15 3.55 48.75 0.00816166 -0.0380896 -0.00814953 0.010256 0.0380813 -0.0102749 0.0 +1976 3.15 3.55 56.25 0.0124306 -0.0965177 -0.0124185 0.0389722 0.0965193 -0.0389853 0.0 +1977 3.15 3.55 63.75 -0.00596526 -0.0594462 0.00595775 0.0133454 0.0594234 -0.0133421 0.0 +1978 3.15 3.55 71.25 -0.00358192 -0.0502022 0.00356674 -0.001576 0.0502323 0.00155584 0.0 +1979 3.15 3.55 78.75 0.000427233 -0.0447805 -0.000397985 -0.000360659 0.0448087 0.000358663 0.0 +1980 3.15 3.55 86.25 0.00221954 -0.0289613 -0.00224103 0.000309741 0.0290046 -0.000307859 0.0 +1981 3.15 3.55 93.75 0.00167606 -0.0143391 -0.0016639 0.000808733 0.0143451 -0.000807743 0.0 +1982 3.15 3.55 101.25 0.00112826 0.001235 -0.00111313 0.000644257 -0.00118443 -0.000655222 0.0 +1983 3.15 3.55 108.75 0.00330286 0.0161835 -0.00328457 -0.00210868 -0.0161684 0.00210336 0.0 +1984 3.15 3.55 116.25 0.00487387 0.021415 -0.00489745 -0.00297998 -0.0214282 0.00298062 0.0 +1985 3.15 3.55 123.75 0.00293975 0.016899 -0.00293859 0.000267886 -0.0168868 -0.000264266 0.0 +1986 3.15 3.55 131.25 -0.000108452 0.0105143 0.000105308 0.0034128 -0.0105219 -0.00340601 0.0 +1987 3.15 3.55 138.75 -0.0019759 0.00532812 0.00199003 0.00354695 -0.00537804 -0.00353067 0.0 +1988 3.15 3.55 146.25 -0.00603215 -0.00319989 0.00603288 0.00350166 0.0031536 -0.00347955 0.0 +1989 3.15 3.55 153.75 -0.0177873 -0.0194322 0.017795 0.00752565 0.0194683 -0.00752983 0.0 +1990 3.15 3.55 161.25 -0.0380423 -0.0418389 0.038072 0.0161592 0.041823 -0.016153 0.0 +1991 3.15 3.55 168.75 -0.0604183 -0.0634358 0.0604406 0.025925 0.0634577 -0.0259272 0.0 +1992 3.15 3.55 176.25 -0.0751419 -0.0766462 0.0751429 0.0322594 0.0766293 -0.0322626 0.0 +1993 3.15 3.65 3.75 22.6045 15.6092 -22.6045 111.52 -15.6092 -111.52 0.0 +1994 3.15 3.65 11.25 14.9574 7.74254 -14.9574 45.5783 -7.74254 -45.5783 0.0 +1995 3.15 3.65 18.75 6.90511 1.96171 -6.90511 12.5917 -1.96171 -12.5917 0.0 +1996 3.15 3.65 26.25 2.1033 0.0752923 -2.1033 2.33462 -0.0752924 -2.33462 0.0 +1997 3.15 3.65 33.75 0.345582 -0.0501268 -0.345582 0.224112 0.0501278 -0.224114 0.0 +1998 3.15 3.65 41.25 0.0113715 0.0247154 -0.0113732 -0.00142732 -0.0247142 0.00142719 0.0 +1999 3.15 3.65 48.75 6.87534e-06 0.0140289 -8.51151e-06 0.00563543 -0.0140289 -0.00563605 0.0 +2000 3.15 3.65 56.25 0.00107984 0.0029724 -0.00108132 0.0085864 -0.00297002 -0.00858758 0.0 +2001 3.15 3.65 63.75 0.000469516 0.00270845 -0.000469271 0.00350089 -0.00271011 -0.00350175 0.0 +2002 3.15 3.65 71.25 0.00166924 0.00153728 -0.00167029 0.000471675 -0.00153501 -0.000472585 0.0 +2003 3.15 3.65 78.75 0.00174748 0.00147027 -0.00174735 0.000292892 -0.00147097 -0.000293091 0.0 +2004 3.15 3.65 86.25 0.000889203 0.00101364 -0.000888457 0.000849106 -0.00101254 -0.000849064 0.0 +2005 3.15 3.65 93.75 2.8391e-05 -0.000779719 -2.40476e-05 0.00107302 0.000781464 -0.0010731 0.0 +2006 3.15 3.65 101.25 0.000123662 -0.00119237 -0.000121972 0.000258462 0.00119287 -0.000258603 0.0 +2007 3.15 3.65 108.75 0.000918738 -7.37641e-05 -0.000914812 -0.00070731 7.40479e-05 0.000707953 0.0 +2008 3.15 3.65 116.25 0.00087327 0.000204194 -0.000871841 -0.000333298 -0.000200322 0.000333731 0.0 +2009 3.15 3.65 123.75 -0.000487938 -0.000958429 0.000488243 0.000977954 0.000952902 -0.000975387 0.0 +2010 3.15 3.65 131.25 -0.00192454 -0.00214305 0.00192471 0.00156629 0.00213806 -0.00156455 0.0 +2011 3.15 3.65 138.75 -0.00245031 -0.00237129 0.00244858 0.000874281 0.00237286 -0.000874291 0.0 +2012 3.15 3.65 146.25 -0.00267054 -0.00197417 0.00267194 -7.6905e-05 0.00197292 7.72814e-05 0.0 +2013 3.15 3.65 153.75 -0.00396803 -0.00167631 0.00396857 -7.83088e-05 0.00167684 7.95127e-05 0.0 +2014 3.15 3.65 161.25 -0.00685387 -0.0017756 0.00685877 0.001108 0.0017796 -0.00110938 0.0 +2015 3.15 3.65 168.75 -0.0103819 -0.00210183 0.0103815 0.00276801 0.00210519 -0.00277039 0.0 +2016 3.15 3.65 176.25 -0.0127948 -0.0023518 0.0127908 0.00391691 0.00234768 -0.00391514 0.0 +2017 3.25 2.55 3.75 -59.5545 -1160.49 59.5545 1973.77 1160.49 -1973.77 0.0 +2018 3.25 2.55 11.25 56.844 -883.608 -56.844 989.381 883.608 -989.381 0.0 +2019 3.25 2.55 18.75 150.984 -517.626 -150.984 245.884 517.626 -245.884 0.0 +2020 3.25 2.55 26.25 157.168 -217.116 -157.168 -29.2846 217.116 29.2846 0.0 +2021 3.25 2.55 33.75 104.452 -35.7233 -104.452 -62.8432 35.7233 62.8432 0.0 +2022 3.25 2.55 41.25 45.7976 43.3017 -45.7976 -37.3073 -43.3018 37.3072 0.0 +2023 3.25 2.55 48.75 9.60869 61.5692 -9.60866 -20.3111 -61.5692 20.3112 0.0 +2024 3.25 2.55 56.25 -4.20215 55.2685 4.20214 -17.2817 -55.2685 17.2817 0.0 +2025 3.25 2.55 63.75 -6.66487 44.7328 6.66491 -19.5438 -44.7328 19.5438 0.0 +2026 3.25 2.55 71.25 -6.50581 36.3932 6.50582 -21.044 -36.3932 21.044 0.0 +2027 3.25 2.55 78.75 -7.21586 29.4638 7.21588 -19.4803 -29.4638 19.4803 0.0 +2028 3.25 2.55 86.25 -8.72782 22.0388 8.72785 -15.2322 -22.0388 15.2322 0.0 +2029 3.25 2.55 93.75 -9.40848 13.7576 9.40845 -10.2135 -13.7576 10.2135 0.0 +2030 3.25 2.55 101.25 -7.64177 5.41324 7.64175 -6.28364 -5.41318 6.28364 0.0 +2031 3.25 2.55 108.75 -2.88942 -2.25162 2.88943 -4.15915 2.25161 4.15916 0.0 +2032 3.25 2.55 116.25 4.12591 -9.02031 -4.1259 -3.45148 9.02031 3.45149 0.0 +2033 3.25 2.55 123.75 11.9997 -14.9628 -11.9997 -3.35136 14.9629 3.35133 0.0 +2034 3.25 2.55 131.25 19.3907 -20.1146 -19.3907 -3.21822 20.1146 3.21823 0.0 +2035 3.25 2.55 138.75 25.4561 -24.4049 -25.456 -2.78061 24.4049 2.78061 0.0 +2036 3.25 2.55 146.25 29.9071 -27.7562 -29.9071 -2.05757 27.7562 2.05754 0.0 +2037 3.25 2.55 153.75 32.8539 -30.1787 -32.854 -1.20409 30.1786 1.2041 0.0 +2038 3.25 2.55 161.25 34.6093 -31.7823 -34.6093 -0.396587 31.7823 0.396598 0.0 +2039 3.25 2.55 168.75 35.53 -32.7268 -35.5301 0.221162 32.7267 -0.221124 0.0 +2040 3.25 2.55 176.25 35.9092 -33.157 -35.9092 0.553508 33.1571 -0.553511 0.0 +2041 3.25 2.65 3.75 -364.619 -1177.24 364.619 3261.15 1177.24 -3261.15 0.0 +2042 3.25 2.65 11.25 -170.944 -882.259 170.944 1601.98 882.259 -1601.98 0.0 +2043 3.25 2.65 18.75 7.97343 -512.971 -7.97344 473.428 512.971 -473.428 0.0 +2044 3.25 2.65 26.25 76.8197 -225.459 -76.8197 55.4429 225.459 -55.4429 0.0 +2045 3.25 2.65 33.75 63.1706 -60.3759 -63.1705 -25.1786 60.3759 25.1786 0.0 +2046 3.25 2.65 41.25 26.9972 9.4952 -26.9972 -17.0011 -9.4952 17.0011 0.0 +2047 3.25 2.65 48.75 3.21426 27.5458 -3.21427 -7.89242 -27.5458 7.89243 0.0 +2048 3.25 2.65 56.25 -4.19276 25.9514 4.19277 -7.71957 -25.9514 7.71956 0.0 +2049 3.25 2.65 63.75 -3.58514 20.9867 3.58512 -10.032 -20.9868 10.032 0.0 +2050 3.25 2.65 71.25 -1.8218 17.5583 1.82182 -11.0933 -17.5583 11.0933 0.0 +2051 3.25 2.65 78.75 -1.42207 15.0684 1.42209 -10.072 -15.0684 10.0719 0.0 +2052 3.25 2.65 86.25 -2.18006 12.0219 2.18006 -7.5761 -12.0219 7.57611 0.0 +2053 3.25 2.65 93.75 -2.7903 8.07822 2.79028 -4.90189 -8.07821 4.9019 0.0 +2054 3.25 2.65 101.25 -2.02796 3.78203 2.02793 -3.09994 -3.78201 3.09993 0.0 +2055 3.25 2.65 108.75 0.483472 -0.355942 -0.483506 -2.39117 0.355959 2.39116 0.0 +2056 3.25 2.65 116.25 4.21545 -4.19385 -4.21545 -2.34867 4.19387 2.34866 0.0 +2057 3.25 2.65 123.75 8.24608 -7.74498 -8.24604 -2.42106 7.74505 2.42104 0.0 +2058 3.25 2.65 131.25 11.8028 -10.9489 -11.8028 -2.27777 10.9489 2.27773 0.0 +2059 3.25 2.65 138.75 14.4961 -13.663 -14.4961 -1.85408 13.663 1.85407 0.0 +2060 3.25 2.65 146.25 16.276 -15.7727 -16.2759 -1.2414 15.7727 1.24142 0.0 +2061 3.25 2.65 153.75 17.2907 -17.2659 -17.2907 -0.574592 17.266 0.574543 0.0 +2062 3.25 2.65 161.25 17.7665 -18.2245 -17.7665 0.0269533 18.2244 -0.0269058 0.0 +2063 3.25 2.65 168.75 17.9306 -18.771 -17.9305 0.475387 18.7711 -0.475413 0.0 +2064 3.25 2.65 176.25 17.963 -19.0139 -17.9629 0.71373 19.0138 -0.713725 0.0 +2065 3.25 2.75 3.75 -650.81 -1112.84 650.81 4991.17 1112.84 -4991.17 0.0 +2066 3.25 2.75 11.25 -376.912 -814.423 376.912 2284.82 814.423 -2284.82 0.0 +2067 3.25 2.75 18.75 -117.877 -461.215 117.877 695.625 461.215 -695.625 0.0 +2068 3.25 2.75 26.25 8.67283 -200.478 -8.67283 127.828 200.478 -127.828 0.0 +2069 3.25 2.75 33.75 30.7578 -59.6663 -30.7577 1.67013 59.6663 -1.67014 0.0 +2070 3.25 2.75 41.25 14.4779 -3.75451 -14.4779 -5.11202 3.75449 5.112 0.0 +2071 3.25 2.75 48.75 0.564337 10.5362 -0.564367 -1.71911 -10.5363 1.71911 0.0 +2072 3.25 2.75 56.25 -2.87617 10.6345 2.87615 -3.06902 -10.6345 3.06903 0.0 +2073 3.25 2.75 63.75 -1.22692 8.54812 1.22688 -4.99683 -8.54813 4.99685 0.0 +2074 3.25 2.75 71.25 0.676625 7.54109 -0.676628 -5.57438 -7.5411 5.57438 0.0 +2075 3.25 2.75 78.75 1.26747 7.12286 -1.26752 -4.88162 -7.12286 4.88162 0.0 +2076 3.25 2.75 86.25 0.821253 6.2155 -0.821271 -3.51573 -6.2155 3.51573 0.0 +2077 3.25 2.75 93.75 0.269172 4.5723 -0.269183 -2.24524 -4.57233 2.24524 0.0 +2078 3.25 2.75 101.25 0.429798 2.5731 -0.429775 -1.56964 -2.57305 1.56964 0.0 +2079 3.25 2.75 108.75 1.51112 0.548777 -1.51111 -1.46189 -0.548758 1.46189 0.0 +2080 3.25 2.75 116.25 3.14107 -1.42811 -3.14111 -1.57905 1.428 1.57906 0.0 +2081 3.25 2.75 123.75 4.77902 -3.35524 -4.77897 -1.60881 3.35532 1.60877 0.0 +2082 3.25 2.75 131.25 6.0623 -5.14646 -6.06231 -1.42923 5.14643 1.42921 0.0 +2083 3.25 2.75 138.75 6.88223 -6.66178 -6.88228 -1.07207 6.66181 1.07204 0.0 +2084 3.25 2.75 146.25 7.29129 -7.80724 -7.29129 -0.62631 7.80721 0.626318 0.0 +2085 3.25 2.75 153.75 7.40168 -8.58128 -7.40163 -0.175775 8.58129 0.175784 0.0 +2086 3.25 2.75 161.25 7.33627 -9.05184 -7.33623 0.217137 9.05186 -0.217144 0.0 +2087 3.25 2.75 168.75 7.21123 -9.30667 -7.21121 0.506879 9.3067 -0.50691 0.0 +2088 3.25 2.75 176.25 7.12142 -9.41579 -7.12147 0.660755 9.41579 -0.660753 0.0 +2089 3.25 2.85 3.75 -874.718 -974.414 874.718 7259.84 974.414 -7259.84 0.0 +2090 3.25 2.85 11.25 -529.957 -697.024 529.957 2965.19 697.024 -2965.19 0.0 +2091 3.25 2.85 18.75 -210.49 -383.275 210.49 886.088 383.275 -886.088 0.0 +2092 3.25 2.85 26.25 -41.3105 -160.664 41.3105 182.067 160.664 -182.067 0.0 +2093 3.25 2.85 33.75 7.80209 -47.4025 -7.8021 18.2185 47.4025 -18.2185 0.0 +2094 3.25 2.85 41.25 6.66425 -6.22131 -6.66427 0.514926 6.22131 -0.514937 0.0 +2095 3.25 2.85 48.75 -0.257506 3.34457 0.257528 0.598091 -3.34461 -0.598088 0.0 +2096 3.25 2.85 56.25 -1.60108 3.68626 1.60109 -1.12836 -3.68629 1.12836 0.0 +2097 3.25 2.85 63.75 -0.0562389 2.92276 0.0562531 -2.4777 -2.92278 2.47769 0.0 +2098 3.25 2.85 71.25 1.34259 2.85177 -1.34259 -2.68723 -2.85177 2.68723 0.0 +2099 3.25 2.85 78.75 1.78217 3.08196 -1.7822 -2.22735 -3.08197 2.22735 0.0 +2100 3.25 2.85 86.25 1.51729 2.94458 -1.51724 -1.5416 -2.94457 1.5416 0.0 +2101 3.25 2.85 93.75 1.11672 2.32415 -1.11672 -1.01515 -2.32408 1.01514 0.0 +2102 3.25 2.85 101.25 1.04827 1.48668 -1.04823 -0.8323 -1.48656 0.832297 0.0 +2103 3.25 2.85 108.75 1.38957 0.621054 -1.38956 -0.889911 -0.621024 0.889912 0.0 +2104 3.25 2.85 116.25 1.89694 -0.261405 -1.89687 -0.969374 0.26136 0.969375 0.0 +2105 3.25 2.85 123.75 2.30175 -1.1663 -2.3017 -0.931747 1.16616 0.931784 0.0 +2106 3.25 2.85 131.25 2.49539 -2.02222 -2.49531 -0.76339 2.02229 0.763392 0.0 +2107 3.25 2.85 138.75 2.50552 -2.72913 -2.50545 -0.516076 2.72907 0.516141 0.0 +2108 3.25 2.85 146.25 2.39795 -3.23443 -2.39795 -0.243855 3.23438 0.243866 0.0 +2109 3.25 2.85 153.75 2.22514 -3.55264 -2.22503 0.0183988 3.55282 -0.0184731 0.0 +2110 3.25 2.85 161.25 2.02888 -3.73535 -2.02881 0.247142 3.73533 -0.247116 0.0 +2111 3.25 2.85 168.75 1.85569 -3.83283 -1.85573 0.419517 3.83292 -0.419559 0.0 +2112 3.25 2.85 176.25 1.75351 -3.87538 -1.75346 0.513033 3.87536 -0.513003 0.0 +2113 3.25 2.95 3.75 -994.675 -761.925 994.675 10167.8 761.925 -10167.8 0.0 +2114 3.25 2.95 11.25 -604.142 -541.804 604.142 3540.59 541.804 -3540.59 0.0 +2115 3.25 2.95 18.75 -258.167 -293.834 258.167 1019.93 293.834 -1019.93 0.0 +2116 3.25 2.95 26.25 -69.6148 -118.714 69.6148 215.024 118.714 -215.024 0.0 +2117 3.25 2.95 33.75 -5.90221 -32.9966 5.90223 26.311 32.9965 -26.3109 0.0 +2118 3.25 2.95 41.25 2.25602 -4.6363 -2.256 2.23549 4.63633 -2.23548 0.0 +2119 3.25 2.95 48.75 -0.381153 0.893766 0.381197 0.984491 -0.893795 -0.984484 0.0 +2120 3.25 2.95 56.25 -0.837566 1.03175 0.837613 -0.404101 -1.03172 0.404103 0.0 +2121 3.25 2.95 63.75 0.175542 0.816121 -0.175492 -1.20167 -0.816067 1.20172 0.0 +2122 3.25 2.95 71.25 0.973076 0.964456 -0.973105 -1.22149 -0.964472 1.22153 0.0 +2123 3.25 2.95 78.75 1.22755 1.20413 -1.22756 -0.952588 -1.20413 0.952604 0.0 +2124 3.25 2.95 86.25 1.11328 1.21193 -1.11325 -0.647389 -1.21189 0.647396 0.0 +2125 3.25 2.95 93.75 0.908821 0.978321 -0.908822 -0.460875 -0.978329 0.460874 0.0 +2126 3.25 2.95 101.25 0.833653 0.675263 -0.833527 -0.437086 -0.675046 0.437092 0.0 +2127 3.25 2.95 108.75 0.892478 0.384331 -0.892482 -0.487806 -0.384525 0.487835 0.0 +2128 3.25 2.95 116.25 0.941912 0.0767676 -0.941915 -0.503087 -0.0768796 0.50313 0.0 +2129 3.25 2.95 123.75 0.880255 -0.264114 -0.880225 -0.441399 0.264088 0.441378 0.0 +2130 3.25 2.95 131.25 0.721429 -0.593478 -0.721462 -0.324258 0.59346 0.324254 0.0 +2131 3.25 2.95 138.75 0.529658 -0.854889 -0.529654 -0.187313 0.854907 0.187341 0.0 +2132 3.25 2.95 146.25 0.343385 -1.03082 -0.343423 -0.0495403 1.03079 0.0495952 0.0 +2133 3.25 2.95 153.75 0.166185 -1.14208 -0.166078 0.084722 1.14224 -0.0847717 0.0 +2134 3.25 2.95 161.25 -0.0023326 -1.21841 0.00240849 0.210111 1.21855 -0.210151 0.0 +2135 3.25 2.95 168.75 -0.143824 -1.27394 0.143828 0.311754 1.27397 -0.311766 0.0 +2136 3.25 2.95 176.25 -0.226551 -1.30554 0.226594 0.369648 1.30568 -0.369696 0.0 +2137 3.25 3.05 3.75 -978.964 -476.941 978.964 13691.9 476.941 -13691.9 0.0 +2138 3.25 3.05 11.25 -585.6 -358.907 585.6 3897.55 358.907 -3897.55 0.0 +2139 3.25 3.05 18.75 -256.707 -201.647 256.707 1079.65 201.647 -1079.65 0.0 +2140 3.25 3.05 26.25 -76.2438 -81.0977 76.2438 226.645 81.0977 -226.645 0.0 +2141 3.25 3.05 33.75 -11.5833 -21.1654 11.5832 28.5061 21.1655 -28.5061 0.0 +2142 3.25 3.05 41.25 0.173619 -2.61963 -0.173607 2.10869 2.61962 -2.10865 0.0 +2143 3.25 3.05 48.75 -0.315471 0.211809 0.315507 0.701655 -0.211816 -0.701697 0.0 +2144 3.25 3.05 56.25 -0.505868 0.156217 0.505813 -0.107758 -0.156216 0.107744 0.0 +2145 3.25 3.05 63.75 -0.00347947 0.148027 0.00347438 -0.508426 -0.147997 0.508423 0.0 +2146 3.25 3.05 71.25 0.35623 0.275174 -0.356316 -0.485913 -0.275183 0.485916 0.0 +2147 3.25 3.05 78.75 0.491691 0.385673 -0.491641 -0.368162 -0.385769 0.368161 0.0 +2148 3.25 3.05 86.25 0.488401 0.383863 -0.48842 -0.257055 -0.383836 0.257051 0.0 +2149 3.25 3.05 93.75 0.440596 0.300647 -0.440558 -0.200164 -0.300597 0.200155 0.0 +2150 3.25 3.05 101.25 0.428503 0.226143 -0.428439 -0.201568 -0.226229 0.201576 0.0 +2151 3.25 3.05 108.75 0.433838 0.178273 -0.433894 -0.215213 -0.17832 0.215235 0.0 +2152 3.25 3.05 116.25 0.381927 0.115261 -0.381976 -0.200265 -0.115315 0.200286 0.0 +2153 3.25 3.05 123.75 0.250762 0.0199942 -0.250749 -0.152978 -0.0201082 0.153022 0.0 +2154 3.25 3.05 131.25 0.087112 -0.0827914 -0.0871943 -0.0925379 0.0827206 0.0925707 0.0 +2155 3.25 3.05 138.75 -0.059018 -0.166424 0.059112 -0.0336172 0.166526 0.0335871 0.0 +2156 3.25 3.05 146.25 -0.18052 -0.231382 0.180489 0.0245779 0.231091 -0.0244228 0.0 +2157 3.25 3.05 153.75 -0.295942 -0.294287 0.2959 0.0891166 0.294365 -0.089183 0.0 +2158 3.25 3.05 161.25 -0.414913 -0.365011 0.414927 0.159436 0.365193 -0.159527 0.0 +2159 3.25 3.05 168.75 -0.521941 -0.433475 0.521891 0.222797 0.433412 -0.22276 0.0 +2160 3.25 3.05 176.25 -0.586773 -0.476695 0.58675 0.260922 0.476694 -0.260927 0.0 +2161 3.25 3.15 3.75 -814.083 -137.448 814.083 17033 137.448 -17033 0.0 +2162 3.25 3.15 11.25 -477.018 -161.776 477.018 3948.26 161.776 -3948.26 0.0 +2163 3.25 3.15 18.75 -210.543 -111.957 210.543 1059.41 111.957 -1059.41 0.0 +2164 3.25 3.15 26.25 -64.7579 -49.5587 64.7579 219.45 49.5587 -219.45 0.0 +2165 3.25 3.15 33.75 -11.3607 -12.9491 11.3607 27.2729 12.9491 -27.2729 0.0 +2166 3.25 3.15 41.25 -0.501683 -1.37447 0.501697 1.5392 1.37448 -1.53919 0.0 +2167 3.25 3.15 48.75 -0.221118 -0.00415248 0.221156 0.373864 0.00412424 -0.373901 0.0 +2168 3.25 3.15 56.25 -0.358361 -0.136291 0.358397 0.0446509 0.136267 -0.0446373 0.0 +2169 3.25 3.15 63.75 -0.169006 -0.0774782 0.16899 -0.134807 0.0776033 0.134847 0.0 +2170 3.25 3.15 71.25 -0.0396525 0.000838949 0.0396204 -0.138164 -0.000965599 0.138113 0.0 +2171 3.25 3.15 78.75 0.0344374 0.0425985 -0.0344408 -0.11517 -0.0427499 0.115165 0.0 +2172 3.25 3.15 86.25 0.081184 0.0529524 -0.0811964 -0.089771 -0.0528817 0.0897804 0.0 +2173 3.25 3.15 93.75 0.109097 0.0469134 -0.109138 -0.0742976 -0.0469756 0.0743061 0.0 +2174 3.25 3.15 101.25 0.140882 0.0567832 -0.140845 -0.0701795 -0.056761 0.0701752 0.0 +2175 3.25 3.15 108.75 0.161799 0.0792193 -0.161837 -0.0654321 -0.0792445 0.0654376 0.0 +2176 3.25 3.15 116.25 0.136212 0.0826416 -0.136185 -0.0509834 -0.082549 0.0509852 0.0 +2177 3.25 3.15 123.75 0.0646484 0.0562433 -0.0646738 -0.0282995 -0.0561666 0.0282081 0.0 +2178 3.25 3.15 131.25 -0.0160401 0.016597 0.0162145 -0.00533023 -0.0166918 0.00541668 0.0 +2179 3.25 3.15 138.75 -0.0817391 -0.0230835 0.0817603 0.0141581 0.0232302 -0.0142084 0.0 +2180 3.25 3.15 146.25 -0.139744 -0.0669364 0.139812 0.0354497 0.0671282 -0.0355434 0.0 +2181 3.25 3.15 153.75 -0.209767 -0.126707 0.209696 0.0659929 0.126592 -0.0659876 0.0 +2182 3.25 3.15 161.25 -0.294722 -0.202261 0.294788 0.105695 0.202334 -0.105724 0.0 +2183 3.25 3.15 168.75 -0.376427 -0.2763 0.376427 0.144617 0.276396 -0.144692 0.0 +2184 3.25 3.15 176.25 -0.426876 -0.322774 0.42683 0.16886 0.322923 -0.168938 0.0 +2185 3.25 3.25 3.75 -516.093 207.353 516.093 17519 -207.353 -17519 0.0 +2186 3.25 3.25 11.25 -297.818 30.2999 297.818 3670.93 -30.2999 -3670.93 0.0 +2187 3.25 3.25 18.75 -131.533 -29.3583 131.533 966.016 29.3582 -966.016 0.0 +2188 3.25 3.25 26.25 -41.2561 -23.5547 41.2561 197.399 23.5547 -197.399 0.0 +2189 3.25 3.25 33.75 -7.77181 -7.42064 7.77175 24.324 7.42059 -24.3239 0.0 +2190 3.25 3.25 41.25 -0.520054 -0.786867 0.520059 1.16473 0.786915 -1.16475 0.0 +2191 3.25 3.25 48.75 -0.135385 -0.107324 0.135384 0.176595 0.107322 -0.176651 0.0 +2192 3.25 3.25 56.25 -0.236403 -0.233969 0.236341 0.100092 0.234021 -0.099998 0.0 +2193 3.25 3.25 63.75 -0.177344 -0.160255 0.177338 0.016127 0.160281 -0.0161542 0.0 +2194 3.25 3.25 71.25 -0.134993 -0.110418 0.134999 -0.0109067 0.110353 0.010913 0.0 +2195 3.25 3.25 78.75 -0.0950825 -0.0779897 0.0951253 -0.021928 0.077927 0.0219105 0.0 +2196 3.25 3.25 86.25 -0.0482799 -0.0371325 0.0482478 -0.0253972 0.0372349 0.0254039 0.0 +2197 3.25 3.25 93.75 -0.00935062 -0.00567433 0.00930825 -0.0233964 0.0056727 0.0233906 0.0 +2198 3.25 3.25 101.25 0.0268556 0.0229776 -0.0268747 -0.016636 -0.0229697 0.0166413 0.0 +2199 3.25 3.25 108.75 0.0559475 0.0486988 -0.0559577 -0.010512 -0.0487913 0.0105343 0.0 +2200 3.25 3.25 116.25 0.0599605 0.0541495 -0.0598537 -0.00538128 -0.0541128 0.00538138 0.0 +2201 3.25 3.25 123.75 0.0386584 0.0352012 -0.038683 0.00205185 -0.0351223 -0.00210039 0.0 +2202 3.25 3.25 131.25 0.0113902 0.00756233 -0.0112221 0.0099077 -0.00759024 -0.00983246 0.0 +2203 3.25 3.25 138.75 -0.0116709 -0.0175027 0.0116404 0.0150778 0.0175656 -0.0151232 0.0 +2204 3.25 3.25 146.25 -0.0379372 -0.0440118 0.0378931 0.0202482 0.0440189 -0.0202764 0.0 +2205 3.25 3.25 153.75 -0.0789016 -0.0826345 0.0789715 0.0309487 0.0826604 -0.0309747 0.0 +2206 3.25 3.25 161.25 -0.13326 -0.134571 0.133258 0.0482225 0.134355 -0.0481305 0.0 +2207 3.25 3.25 168.75 -0.185796 -0.186751 0.185766 0.0666972 0.186837 -0.0667545 0.0 +2208 3.25 3.25 176.25 -0.217924 -0.219808 0.217907 0.078575 0.219826 -0.0785566 0.0 +2209 3.25 3.35 3.75 -136.489 468.84 136.489 13261.2 -468.84 -13261.2 0.0 +2210 3.25 3.35 11.25 -76.3677 186.541 76.3677 3006.19 -186.541 -3006.19 0.0 +2211 3.25 3.35 18.75 -34.4387 38.7843 34.4388 785.234 -38.7843 -785.234 0.0 +2212 3.25 3.35 26.25 -12.2064 -2.42532 12.2063 158.413 2.42535 -158.413 0.0 +2213 3.25 3.35 33.75 -3.01753 -3.19124 3.01752 19.5862 3.19127 -19.5862 0.0 +2214 3.25 3.35 41.25 -0.376538 -0.403329 0.376502 0.965951 0.403384 -0.965979 0.0 +2215 3.25 3.35 48.75 -0.0663706 -0.151905 0.066354 0.0762885 0.151928 -0.0763483 0.0 +2216 3.25 3.35 56.25 -0.115811 -0.241426 0.115854 0.0757353 0.241441 -0.0756865 0.0 +2217 3.25 3.35 63.75 -0.10133 -0.1561 0.101333 0.0257088 0.156123 -0.0256754 0.0 +2218 3.25 3.35 71.25 -0.0830317 -0.123866 0.083011 0.00222966 0.123776 -0.00226914 0.0 +2219 3.25 3.35 78.75 -0.0648663 -0.0963338 0.0649114 -0.00193966 0.0962687 0.00191896 0.0 +2220 3.25 3.35 86.25 -0.0348832 -0.0452658 0.0348888 -0.00953403 0.0452114 0.00953002 0.0 +2221 3.25 3.35 93.75 -0.00930256 -0.00606384 0.00931036 -0.0124204 0.00592252 0.0124271 0.0 +2222 3.25 3.35 101.25 0.0100895 0.0236635 -0.0100704 -0.00601918 -0.0236457 0.00599972 0.0 +2223 3.25 3.35 108.75 0.0265883 0.0477513 -0.0265736 -0.00229502 -0.0475016 0.00223504 0.0 +2224 3.25 3.35 116.25 0.0315534 0.0512958 -0.0315658 -0.00201565 -0.0511774 0.00205073 0.0 +2225 3.25 3.35 123.75 0.0223392 0.0342892 -0.0222605 0.00148067 -0.0341723 -0.00152918 0.0 +2226 3.25 3.35 131.25 0.00941799 0.0153327 -0.00949539 0.00600099 -0.015387 -0.00602979 0.0 +2227 3.25 3.35 138.75 0.00192308 0.00676484 -0.0019709 0.00587968 -0.0067599 -0.00587268 0.0 +2228 3.25 3.35 146.25 -0.00390089 0.00228314 0.00390376 0.00216232 -0.00224221 -0.00219 0.0 +2229 3.25 3.35 153.75 -0.0157319 -0.00974298 0.0157634 0.000201998 0.00958756 -0.00010215 0.0 +2230 3.25 3.35 161.25 -0.0344272 -0.0332355 0.0345224 0.00245974 0.0332678 -0.00241767 0.0 +2231 3.25 3.35 168.75 -0.0539332 -0.0604648 0.0538857 0.00692496 0.0604662 -0.00693555 0.0 +2232 3.25 3.35 176.25 -0.0657833 -0.0784772 0.0659121 0.0101981 0.0784511 -0.0101316 0.0 +2233 3.25 3.45 3.75 160.753 453.103 -160.753 6268.16 -453.103 -6268.16 0.0 +2234 3.25 3.45 11.25 98.9204 211.866 -98.9204 1677.08 -211.866 -1677.08 0.0 +2235 3.25 3.45 18.75 41.6475 62.0615 -41.6475 437.04 -62.0615 -437.04 0.0 +2236 3.25 3.45 26.25 10.2776 8.85177 -10.2776 86.3962 -8.85176 -86.3962 0.0 +2237 3.25 3.45 33.75 0.665198 -0.0281349 -0.665216 10.5941 0.0281541 -10.5942 0.0 +2238 3.25 3.45 41.25 -0.225316 -0.0097665 0.225331 0.540446 0.00977707 -0.540423 0.0 +2239 3.25 3.45 48.75 -0.000555537 -0.138966 0.000568013 0.0245727 0.138941 -0.0245583 0.0 +2240 3.25 3.45 56.25 -0.0247081 -0.191676 0.0246253 0.0387653 0.191736 -0.0387721 0.0 +2241 3.25 3.45 63.75 -0.0406244 -0.104835 0.0405644 0.00218269 0.104904 -0.00218938 0.0 +2242 3.25 3.45 71.25 -0.0316041 -0.0868229 0.0315861 -0.00999292 0.086857 0.00997278 0.0 +2243 3.25 3.45 78.75 -0.0244453 -0.0766617 0.0244139 -0.00348801 0.076724 0.00349178 0.0 +2244 3.25 3.45 86.25 -0.00890648 -0.0447902 0.00892778 -0.00721057 0.0446984 0.00720699 0.0 +2245 3.25 3.45 93.75 0.00249213 -0.015882 -0.00250762 -0.00859341 0.0157787 0.00859132 0.0 +2246 3.25 3.45 101.25 0.00593138 0.0124111 -0.00596771 -0.00363029 -0.0123966 0.00362055 0.0 +2247 3.25 3.45 108.75 0.00849249 0.0372762 -0.00846232 -0.00245363 -0.0373616 0.0024942 0.0 +2248 3.25 3.45 116.25 0.00730472 0.0430354 -0.00734682 -0.00257204 -0.0430353 0.00254668 0.0 +2249 3.25 3.45 123.75 0.000252497 0.0319203 -0.000228003 0.00117018 -0.0317262 -0.00121273 0.0 +2250 3.25 3.45 131.25 -0.00509858 0.0202249 0.00511462 0.00424735 -0.0201591 -0.00429141 0.0 +2251 3.25 3.45 138.75 -0.00189225 0.0157697 0.00192964 0.00188411 -0.0157307 -0.00190094 0.0 +2252 3.25 3.45 146.25 0.00595475 0.0116431 -0.0059073 -0.0030478 -0.0116606 0.00308588 0.0 +2253 3.25 3.45 153.75 0.00984054 -0.000318014 -0.00985575 -0.00518825 0.000191851 0.00524895 0.0 +2254 3.25 3.45 161.25 0.00625952 -0.0201284 -0.00627072 -0.00318494 0.0201728 0.00314475 0.0 +2255 3.25 3.45 168.75 -0.00150526 -0.0406308 0.00144698 0.000485931 0.0405933 -0.00047182 0.0 +2256 3.25 3.45 176.25 -0.00732316 -0.0533522 0.00734119 0.00300328 0.0532394 -0.0029465 0.0 +2257 3.25 3.55 3.75 170.017 215.704 -170.017 1682.14 -215.704 -1682.14 0.0 +2258 3.25 3.55 11.25 104.65 108.392 -104.65 523.152 -108.392 -523.152 0.0 +2259 3.25 3.55 18.75 44.2579 34.3622 -44.2579 134.428 -34.3622 -134.428 0.0 +2260 3.25 3.55 26.25 11.5313 6.21431 -11.5313 25.1215 -6.2143 -25.1215 0.0 +2261 3.25 3.55 33.75 1.18823 0.636226 -1.18825 2.77896 -0.636222 -2.77896 0.0 +2262 3.25 3.55 41.25 -0.090997 0.150717 0.0909756 0.0854078 -0.1507 -0.0854088 0.0 +2263 3.25 3.55 48.75 0.0364606 -0.051279 -0.0364402 0.0168919 0.0512661 -0.0168927 0.0 +2264 3.25 3.55 56.25 0.0111486 -0.090247 -0.0111456 0.0363843 0.090261 -0.0363792 0.0 +2265 3.25 3.55 63.75 -0.0105072 -0.0440459 0.0105073 0.00831444 0.0440284 -0.00831955 0.0 +2266 3.25 3.55 71.25 -0.00433658 -0.0361287 0.00434277 -0.00361399 0.0361351 0.00360689 0.0 +2267 3.25 3.55 78.75 -0.000933427 -0.0350331 0.000939583 -0.00100115 0.0350187 0.00100048 0.0 +2268 3.25 3.55 86.25 0.00219006 -0.0262185 -0.00219325 -0.00134055 0.0262088 0.0013392 0.0 +2269 3.25 3.55 93.75 0.00205156 -0.0171976 -0.00207372 -0.0011449 0.0171792 0.00114581 0.0 +2270 3.25 3.55 101.25 0.000259054 -0.00345069 -0.000235304 -0.00113486 0.00346766 0.00114093 0.0 +2271 3.25 3.55 108.75 0.00134517 0.0104896 -0.0013327 -0.00307345 -0.0104784 0.00307104 0.0 +2272 3.25 3.55 116.25 0.00233262 0.0144818 -0.00234223 -0.00230586 -0.0144733 0.00230359 0.0 +2273 3.25 3.55 123.75 0.00096001 0.00998525 -0.000959656 0.00167455 -0.00992985 -0.00169886 0.0 +2274 3.25 3.55 131.25 0.0010997 0.00500791 -0.00110082 0.00353768 -0.00496742 -0.00356791 0.0 +2275 3.25 3.55 138.75 0.00487751 0.00146684 -0.00487922 0.00142544 -0.00148711 -0.00141137 0.0 +2276 3.25 3.55 146.25 0.00734264 -0.00446313 -0.00734662 -0.000638225 0.00441882 0.000652058 0.0 +2277 3.25 3.55 153.75 0.00197693 -0.014869 -0.00196668 0.0013558 0.0148847 -0.00135051 0.0 +2278 3.25 3.55 161.25 -0.0121606 -0.0275418 0.0121409 0.00720885 0.027516 -0.00721154 0.0 +2279 3.25 3.55 168.75 -0.029033 -0.0382301 0.0290399 0.0137359 0.0382374 -0.01375 0.0 +2280 3.25 3.55 176.25 -0.0403659 -0.0441543 0.0403287 0.0177986 0.0441199 -0.0177946 0.0 +2281 3.25 3.65 3.75 29.8469 23.7536 -29.8469 114.399 -23.7536 -114.399 0.0 +2282 3.25 3.65 11.25 18.5821 12.1922 -18.5821 38.9798 -12.1922 -38.9798 0.0 +2283 3.25 3.65 18.75 7.82427 3.7514 -7.82427 9.32709 -3.7514 -9.32709 0.0 +2284 3.25 3.65 26.25 2.01633 0.610607 -2.01633 1.41075 -0.610606 -1.41076 0.0 +2285 3.25 3.65 33.75 0.207925 0.0661693 -0.207923 0.0650148 -0.0661712 -0.0650166 0.0 +2286 3.25 3.65 41.25 -0.0109411 0.0374143 0.0109448 -0.0172484 -0.0374174 0.0172482 0.0 +2287 3.25 3.65 48.75 0.00854362 0.00771035 -0.00854147 0.00574961 -0.00770984 -0.00574854 0.0 +2288 3.25 3.65 56.25 0.00259756 -0.00264422 -0.00260097 0.00942854 0.00264499 -0.00942948 0.0 +2289 3.25 3.65 63.75 -0.000120554 0.00078573 0.00012058 0.00313857 -0.000784598 -0.00313891 0.0 +2290 3.25 3.65 71.25 0.00248101 0.00185637 -0.00248337 0.000268246 -0.00186001 -0.000268224 0.0 +2291 3.25 3.65 78.75 0.00307847 0.00208771 -0.00307844 0.000606822 -0.00209071 -0.000606483 0.0 +2292 3.25 3.65 86.25 0.00187174 0.00124659 -0.00186937 0.00095551 -0.00124275 -0.000955129 0.0 +2293 3.25 3.65 93.75 6.19913e-05 -0.000371204 -6.04736e-05 0.000563209 0.000365014 -0.000562734 0.0 +2294 3.25 3.65 101.25 -0.000928172 -0.000436879 0.000926995 -0.00063032 0.000434748 0.000630276 0.0 +2295 3.25 3.65 108.75 -0.000830659 0.000473082 0.000832415 -0.00140972 -0.00047285 0.00140969 0.0 +2296 3.25 3.65 116.25 -0.000942827 0.000407146 0.00094397 -0.000633585 -0.000410022 0.000634706 0.0 +2297 3.25 3.65 123.75 -0.00166283 -0.000582597 0.001662 0.000718962 0.000586269 -0.000719648 0.0 +2298 3.25 3.65 131.25 -0.00204479 -0.00128755 0.00204388 0.000938967 0.00128792 -0.000939369 0.0 +2299 3.25 3.65 138.75 -0.00182542 -0.00123409 0.00182692 -0.000123482 0.00123642 0.000123147 0.0 +2300 3.25 3.65 146.25 -0.00225266 -0.000702446 0.00225351 -0.00119521 0.000700296 0.00119733 0.0 +2301 3.25 3.65 153.75 -0.00470753 0.000107114 0.0047067 -0.00120089 -0.000106024 0.00120018 0.0 +2302 3.25 3.65 161.25 -0.00916233 0.00120265 0.0091593 -0.000139049 -0.00120213 0.000137897 0.0 +2303 3.25 3.65 168.75 -0.0140233 0.0024012 0.0140238 0.00124784 -0.00240054 -0.00124848 0.0 +2304 3.25 3.65 176.25 -0.0171689 0.00321938 0.0171732 0.00216427 -0.00322149 -0.00216221 0.0 +2305 3.35 2.55 3.75 -195.276 -1032.14 195.276 1295.85 1032.14 -1295.85 0.0 +2306 3.35 2.55 11.25 -99.2481 -778.391 99.2481 692.781 778.391 -692.781 0.0 +2307 3.35 2.55 18.75 -6.65643 -434.466 6.65643 206.152 434.466 -206.152 0.0 +2308 3.35 2.55 26.25 25.3003 -148.262 -25.3003 18.5522 148.262 -18.5522 0.0 +2309 3.35 2.55 33.75 11.0692 22.9807 -11.0692 -10.9237 -22.9807 10.9237 0.0 +2310 3.35 2.55 41.25 -11.4134 92.7283 11.4135 -6.39065 -92.7283 6.39065 0.0 +2311 3.35 2.55 48.75 -20.2925 102.13 20.2925 -10.1964 -102.13 10.1964 0.0 +2312 3.35 2.55 56.25 -15.5576 88.407 15.5576 -21.035 -88.4069 21.035 0.0 +2313 3.35 2.55 63.75 -6.26392 72.4403 6.2639 -30.0768 -72.4402 30.0768 0.0 +2314 3.35 2.55 71.25 0.338232 60.0655 -0.338249 -32.7453 -60.0655 32.7453 0.0 +2315 3.35 2.55 78.75 1.98951 49.4255 -1.98942 -28.9805 -49.4255 28.9805 0.0 +2316 3.35 2.55 86.25 0.388913 37.8715 -0.388957 -21.6256 -37.8715 21.6256 0.0 +2317 3.35 2.55 93.75 -1.06672 24.8252 1.06667 -14.3056 -24.8253 14.3056 0.0 +2318 3.35 2.55 101.25 0.391277 11.1758 -0.391251 -9.35123 -11.1758 9.35124 0.0 +2319 3.35 2.55 108.75 5.52125 -2.10395 -5.52124 -7.05211 2.10392 7.05212 0.0 +2320 3.35 2.55 116.25 13.2016 -14.4695 -13.2016 -6.36669 14.4695 6.36669 0.0 +2321 3.35 2.55 123.75 21.5401 -25.5906 -21.5401 -6.05939 25.5905 6.0594 0.0 +2322 3.35 2.55 131.25 28.9456 -35.1239 -28.9457 -5.38465 35.1239 5.38469 0.0 +2323 3.35 2.55 138.75 34.5957 -42.757 -34.5957 -4.17193 42.757 4.17195 0.0 +2324 3.35 2.55 146.25 38.3688 -48.3714 -38.3688 -2.60245 48.3714 2.60243 0.0 +2325 3.35 2.55 153.75 40.566 -52.1207 -40.566 -0.967925 52.1205 0.967988 0.0 +2326 3.35 2.55 161.25 41.6506 -54.3691 -41.6506 0.469012 54.3691 -0.468989 0.0 +2327 3.35 2.55 168.75 42.0782 -55.5528 -42.0782 1.52064 55.5528 -1.52067 0.0 +2328 3.35 2.55 176.25 42.1981 -56.041 -42.1981 2.0729 56.0409 -2.0729 0.0 +2329 3.35 2.65 3.75 -419.098 -1076.13 419.098 2153.24 1076.13 -2153.24 0.0 +2330 3.35 2.65 11.25 -264.945 -806.91 264.945 1138.5 806.91 -1138.5 0.0 +2331 3.35 2.65 18.75 -104.618 -457.574 104.618 379.324 457.574 -379.324 0.0 +2332 3.35 2.65 26.25 -21.9706 -179.872 21.9706 82.5542 179.872 -82.5542 0.0 +2333 3.35 2.65 33.75 -6.05842 -20.7051 6.05842 16.3126 20.7051 -16.3126 0.0 +2334 3.35 2.65 41.25 -13.3029 42.8912 13.3029 8.09772 -42.8912 -8.09772 0.0 +2335 3.35 2.65 48.75 -15.6897 54.0943 15.6897 0.0182538 -54.0943 -0.0182479 0.0 +2336 3.35 2.65 56.25 -9.08183 46.7632 9.08183 -10.6957 -46.7632 10.6957 0.0 +2337 3.35 2.65 63.75 0.136459 38.1374 -0.136456 -17.9284 -38.1374 17.9284 0.0 +2338 3.35 2.65 71.25 6.42034 32.5591 -6.42031 -19.5836 -32.5591 19.5836 0.0 +2339 3.35 2.65 78.75 8.18095 28.2195 -8.18103 -16.7768 -28.2195 16.7768 0.0 +2340 3.35 2.65 86.25 6.86543 22.8055 -6.86542 -12.0332 -22.8055 12.0332 0.0 +2341 3.35 2.65 93.75 5.15555 15.8036 -5.15553 -7.84684 -15.8036 7.84684 0.0 +2342 3.35 2.65 101.25 5.16175 7.93989 -5.16173 -5.47191 -7.93991 5.47192 0.0 +2343 3.35 2.65 108.75 7.39932 -0.00491049 -7.39931 -4.70878 0.00495997 4.70878 0.0 +2344 3.35 2.65 116.25 11.02 -7.59843 -11.02 -4.63522 7.59841 4.63521 0.0 +2345 3.35 2.65 123.75 14.7619 -14.5482 -14.7618 -4.43686 14.5482 4.43688 0.0 +2346 3.35 2.65 131.25 17.7243 -20.5254 -17.7243 -3.76779 20.5254 3.7678 0.0 +2347 3.35 2.65 138.75 19.587 -25.2345 -19.587 -2.6757 25.2346 2.67568 0.0 +2348 3.35 2.65 146.25 20.4495 -28.5646 -20.4495 -1.38054 28.5646 1.38055 0.0 +2349 3.35 2.65 153.75 20.5999 -30.6433 -20.5999 -0.109613 30.6433 0.109611 0.0 +2350 3.35 2.65 161.25 20.3618 -31.7671 -20.3618 0.96685 31.767 -0.966847 0.0 +2351 3.35 2.65 168.75 20.022 -32.2781 -20.022 1.7383 32.278 -1.73826 0.0 +2352 3.35 2.65 176.25 19.7947 -32.4568 -19.7946 2.13939 32.4568 -2.13939 0.0 +2353 3.35 2.75 3.75 -623.075 -1035.97 623.075 3278.31 1035.97 -3278.31 0.0 +2354 3.35 2.75 11.25 -410.652 -765.022 410.652 1641.05 765.022 -1641.05 0.0 +2355 3.35 2.75 18.75 -187.486 -428.713 187.486 547.291 428.713 -547.291 0.0 +2356 3.35 2.75 26.25 -59.4311 -173.568 59.4311 133.12 173.568 -133.12 0.0 +2357 3.35 2.75 33.75 -17.2303 -35.1265 17.2302 31.786 35.1264 -31.786 0.0 +2358 3.35 2.75 41.25 -12.1098 17.1178 12.1099 13.8192 -17.1178 -13.8193 0.0 +2359 3.35 2.75 48.75 -10.4656 26.5604 10.4656 3.88378 -26.5604 -3.88377 0.0 +2360 3.35 2.75 56.25 -4.13597 22.6167 4.136 -5.48779 -22.6166 5.48779 0.0 +2361 3.35 2.75 63.75 3.31091 18.3493 -3.31091 -10.6986 -18.3493 10.6986 0.0 +2362 3.35 2.75 71.25 8.14692 16.4609 -8.14686 -11.4323 -16.4609 11.4323 0.0 +2363 3.35 2.75 78.75 9.44923 15.3065 -9.44926 -9.35408 -15.3065 9.35408 0.0 +2364 3.35 2.75 86.25 8.34302 13.115 -8.34302 -6.45209 -13.115 6.45209 0.0 +2365 3.35 2.75 93.75 6.73127 9.59264 -6.73125 -4.25534 -9.59267 4.25533 0.0 +2366 3.35 2.75 101.25 6.04641 5.36361 -6.04642 -3.28804 -5.36363 3.28804 0.0 +2367 3.35 2.75 108.75 6.5681 1.00824 -6.56803 -3.16383 -1.00821 3.16382 0.0 +2368 3.35 2.75 116.25 7.69424 -3.1996 -7.69426 -3.20291 3.19971 3.20288 0.0 +2369 3.35 2.75 123.75 8.6827 -7.07441 -8.68271 -2.95679 7.07435 2.9568 0.0 +2370 3.35 2.75 131.25 9.13874 -10.3765 -9.13876 -2.33529 10.3765 2.3353 0.0 +2371 3.35 2.75 138.75 9.04359 -12.8901 -9.04363 -1.46655 12.8901 1.46658 0.0 +2372 3.35 2.75 146.25 8.56433 -14.5486 -8.56434 -0.526226 14.5485 0.526253 0.0 +2373 3.35 2.75 153.75 7.89764 -15.464 -7.89766 0.348926 15.464 -0.348943 0.0 +2374 3.35 2.75 161.25 7.21578 -15.8591 -7.2158 1.07115 15.859 -1.0711 0.0 +2375 3.35 2.75 168.75 6.66389 -15.9703 -6.6639 1.58421 15.9702 -1.5842 0.0 +2376 3.35 2.75 176.25 6.3556 -15.9786 -6.35561 1.85074 15.9787 -1.85078 0.0 +2377 3.35 2.85 3.75 -772.698 -919.877 772.698 4708.12 919.877 -4708.12 0.0 +2378 3.35 2.85 11.25 -511.822 -669.074 511.822 2155.18 669.074 -2155.18 0.0 +2379 3.35 2.85 18.75 -243.045 -367.941 243.045 691.364 367.941 -691.364 0.0 +2380 3.35 2.85 26.25 -83.2742 -147.185 83.2742 166.912 147.185 -166.912 0.0 +2381 3.35 2.85 33.75 -22.8244 -33.6483 22.8244 37.1489 33.6483 -37.1488 0.0 +2382 3.35 2.85 41.25 -9.53454 5.8483 9.53452 13.5783 -5.8483 -13.5783 0.0 +2383 3.35 2.85 48.75 -6.09018 12.291 6.09017 4.14913 -12.291 -4.14911 0.0 +2384 3.35 2.85 56.25 -1.26771 10.0666 1.26769 -3.04808 -10.0666 3.04809 0.0 +2385 3.35 2.85 63.75 3.7759 8.1959 -3.77587 -6.37734 -8.19594 6.37731 0.0 +2386 3.35 2.85 71.25 6.89166 7.92994 -6.89164 -6.4809 -7.92993 6.48089 0.0 +2387 3.35 2.85 78.75 7.67029 7.93236 -7.67027 -5.01743 -7.93236 5.01743 0.0 +2388 3.35 2.85 86.25 6.86704 7.07559 -6.86708 -3.3556 -7.07557 3.3556 0.0 +2389 3.35 2.85 93.75 5.65228 5.32847 -5.65231 -2.30528 -5.32852 2.30528 0.0 +2390 3.35 2.85 101.25 4.87116 3.215 -4.87125 -1.98423 -3.21505 1.98422 0.0 +2391 3.35 2.85 108.75 4.63041 1.1067 -4.6304 -2.02318 -1.10679 2.0232 0.0 +2392 3.35 2.85 116.25 4.54443 -0.892094 -4.54436 -2.003 0.892026 2.00303 0.0 +2393 3.35 2.85 123.75 4.25373 -2.7196 -4.25376 -1.73147 2.7196 1.73148 0.0 +2394 3.35 2.85 131.25 3.67676 -4.24518 -3.67683 -1.23922 4.24515 1.23922 0.0 +2395 3.35 2.85 138.75 2.92527 -5.34331 -2.92524 -0.644988 5.34322 0.64504 0.0 +2396 3.35 2.85 146.25 2.13491 -5.99066 -2.135 -0.0510476 5.99066 0.051009 0.0 +2397 3.35 2.85 153.75 1.39275 -6.27569 -1.39282 0.483407 6.27566 -0.483401 0.0 +2398 3.35 2.85 161.25 0.754236 -6.34028 -0.754226 0.924147 6.34015 -0.924067 0.0 +2399 3.35 2.85 168.75 0.275676 -6.31398 -0.275689 1.24213 6.314 -1.24219 0.0 +2400 3.35 2.85 176.25 0.0164689 -6.28159 -0.0164513 1.40997 6.28154 -1.40995 0.0 +2401 3.35 2.95 3.75 -834.912 -728.644 834.912 6476.41 728.644 -6476.41 0.0 +2402 3.35 2.95 11.25 -547.497 -530.188 547.497 2613.47 530.188 -2613.47 0.0 +2403 3.35 2.95 18.75 -262.248 -290.02 262.248 793.304 290.02 -793.304 0.0 +2404 3.35 2.95 26.25 -91.3227 -113.901 91.3227 183.027 113.901 -183.027 0.0 +2405 3.35 2.95 33.75 -23.4608 -26.232 23.4608 35.3151 26.232 -35.3151 0.0 +2406 3.35 2.95 41.25 -6.66345 1.76515 6.66345 10.2484 -1.76515 -10.2484 0.0 +2407 3.35 2.95 48.75 -3.09293 5.49926 3.09291 2.9506 -5.49927 -2.95059 0.0 +2408 3.35 2.95 56.25 -0.128908 4.20301 0.128901 -1.8156 -4.20296 1.81563 0.0 +2409 3.35 2.95 63.75 2.69811 3.54905 -2.69809 -3.66338 -3.54904 3.66335 0.0 +2410 3.35 2.95 71.25 4.37067 3.76567 -4.37061 -3.47926 -3.76571 3.47927 0.0 +2411 3.35 2.95 78.75 4.78503 3.92124 -4.78501 -2.55161 -3.92135 2.55159 0.0 +2412 3.35 2.95 86.25 4.343 3.47426 -4.34301 -1.68279 -3.47427 1.6828 0.0 +2413 3.35 2.95 93.75 3.62999 2.57963 -3.62993 -1.22603 -2.57969 1.22603 0.0 +2414 3.35 2.95 101.25 3.06714 1.6304 -3.06715 -1.13714 -1.63033 1.13713 0.0 +2415 3.35 2.95 108.75 2.6714 0.806801 -2.67137 -1.16012 -0.806856 1.16013 0.0 +2416 3.35 2.95 116.25 2.22983 0.0794546 -2.22987 -1.08361 -0.0795543 1.0836 0.0 +2417 3.35 2.95 123.75 1.62198 -0.581679 -1.62197 -0.855095 0.581669 0.855109 0.0 +2418 3.35 2.95 131.25 0.911108 -1.12896 -0.911104 -0.532177 1.12888 0.532245 0.0 +2419 3.35 2.95 138.75 0.221326 -1.50232 -0.221315 -0.188004 1.50224 0.188057 0.0 +2420 3.35 2.95 146.25 -0.381126 -1.7 0.381078 0.137706 1.6999 -0.137646 0.0 +2421 3.35 2.95 153.75 -0.893851 -1.77735 0.893832 0.432684 1.77726 -0.432674 0.0 +2422 3.35 2.95 161.25 -1.32378 -1.80097 1.32382 0.687059 1.80096 -0.687066 0.0 +2423 3.35 2.95 168.75 -1.6499 -1.81175 1.64995 0.880202 1.81183 -0.880216 0.0 +2424 3.35 2.95 176.25 -1.82978 -1.81925 1.82977 0.985879 1.81919 -0.985873 0.0 +2425 3.35 3.05 3.75 -785.046 -461.717 785.046 8594.91 461.717 -8594.91 0.0 +2426 3.35 3.05 11.25 -505.888 -356.771 505.888 2934.01 356.771 -2934.01 0.0 +2427 3.35 3.05 18.75 -241.842 -203.918 241.842 839.22 203.918 -839.22 0.0 +2428 3.35 3.05 26.25 -83.9245 -81.0674 83.9245 182.984 81.0674 -182.984 0.0 +2429 3.35 3.05 33.75 -20.2141 -18.5085 20.2141 29.6979 18.5085 -29.6979 0.0 +2430 3.35 3.05 41.25 -4.1047 0.409433 4.10472 6.22641 -0.409475 -6.22641 0.0 +2431 3.35 3.05 48.75 -1.36284 2.35911 1.3628 1.60979 -2.35909 -1.60978 0.0 +2432 3.35 3.05 56.25 0.030431 1.62567 -0.030424 -1.01802 -1.6257 1.018 0.0 +2433 3.35 3.05 63.75 1.27646 1.51737 -1.27639 -1.88571 -1.51743 1.88574 0.0 +2434 3.35 3.05 71.25 2.00146 1.74382 -2.00153 -1.67715 -1.74388 1.67713 0.0 +2435 3.35 3.05 78.75 2.22947 1.7724 -2.22943 -1.1839 -1.77249 1.1839 0.0 +2436 3.35 3.05 86.25 2.09366 1.4585 -2.09372 -0.787813 -1.45856 0.787813 0.0 +2437 3.35 3.05 93.75 1.79746 1.00626 -1.79749 -0.60616 -1.00615 0.606162 0.0 +2438 3.35 3.05 101.25 1.51527 0.661229 -1.51529 -0.575074 -0.661245 0.575087 0.0 +2439 3.35 3.05 108.75 1.24058 0.468536 -1.24057 -0.561828 -0.468484 0.561787 0.0 +2440 3.35 3.05 116.25 0.876962 0.332896 -0.876938 -0.482689 -0.332964 0.482687 0.0 +2441 3.35 3.05 123.75 0.416156 0.186434 -0.416121 -0.336497 -0.18647 0.336515 0.0 +2442 3.35 3.05 131.25 -0.0499558 0.038764 0.0498225 -0.163924 -0.0389844 0.163982 0.0 +2443 3.35 3.05 138.75 -0.440256 -0.0796634 0.440301 0.00362958 0.0796422 -0.00361361 0.0 +2444 3.35 3.05 146.25 -0.749289 -0.169351 0.749274 0.161127 0.169574 -0.161167 0.0 +2445 3.35 3.05 153.75 -1.01485 -0.254878 1.01491 0.314525 0.254752 -0.314449 0.0 +2446 3.35 3.05 161.25 -1.25872 -0.351609 1.25877 0.460297 0.351661 -0.460329 0.0 +2447 3.35 3.05 168.75 -1.46132 -0.446415 1.46128 0.579664 0.446487 -0.579718 0.0 +2448 3.35 3.05 176.25 -1.5791 -0.506807 1.57912 0.64783 0.506772 -0.647769 0.0 +2449 3.35 3.15 3.75 -613.346 -128.944 613.346 10936.8 128.944 -10936.8 0.0 +2450 3.35 3.15 11.25 -388.42 -159.752 388.42 3039.67 159.752 -3039.67 0.0 +2451 3.35 3.15 18.75 -185.578 -114.971 185.578 822.812 114.971 -822.812 0.0 +2452 3.35 3.15 26.25 -64.0967 -51.2619 64.0967 169.928 51.2619 -169.928 0.0 +2453 3.35 3.15 33.75 -14.6003 -12.3908 14.6002 23.2626 12.3908 -23.2627 0.0 +2454 3.35 3.15 41.25 -2.15789 -0.18353 2.15785 3.0437 0.183543 -3.04367 0.0 +2455 3.35 3.15 48.75 -0.515911 0.863817 0.515956 0.688645 -0.863876 -0.688622 0.0 +2456 3.35 3.15 56.25 -0.10478 0.478921 0.1048 -0.434933 -0.478877 0.434918 0.0 +2457 3.35 3.15 63.75 0.278403 0.550597 -0.278425 -0.770867 -0.550582 0.770892 0.0 +2458 3.35 3.15 71.25 0.518182 0.679229 -0.518188 -0.658783 -0.679258 0.658773 0.0 +2459 3.35 3.15 78.75 0.661602 0.637382 -0.661573 -0.463196 -0.63745 0.463179 0.0 +2460 3.35 3.15 86.25 0.697289 0.449817 -0.697335 -0.319991 -0.449817 0.319985 0.0 +2461 3.35 3.15 93.75 0.640594 0.258804 -0.6406 -0.254833 -0.258796 0.254831 0.0 +2462 3.35 3.15 101.25 0.556527 0.18774 -0.556486 -0.235323 -0.187938 0.235367 0.0 +2463 3.35 3.15 108.75 0.446937 0.222191 -0.446909 -0.215213 -0.222297 0.215245 0.0 +2464 3.35 3.15 116.25 0.274348 0.26483 -0.274369 -0.168371 -0.264953 0.168437 0.0 +2465 3.35 3.15 123.75 0.0574631 0.256391 -0.0574175 -0.0982881 -0.25635 0.0982953 0.0 +2466 3.35 3.15 131.25 -0.138437 0.203868 0.138469 -0.0233365 -0.203754 0.023301 0.0 +2467 3.35 3.15 138.75 -0.278798 0.131654 0.27879 0.0462375 -0.131622 -0.0462824 0.0 +2468 3.35 3.15 146.25 -0.386441 0.0434165 0.386373 0.115347 -0.0435636 -0.115286 0.0 +2469 3.35 3.15 153.75 -0.50135 -0.0699762 0.50138 0.191887 0.0700475 -0.191868 0.0 +2470 3.35 3.15 161.25 -0.635272 -0.204478 0.635288 0.273074 0.204491 -0.273059 0.0 +2471 3.35 3.15 168.75 -0.76189 -0.331252 0.762029 0.343855 0.331256 -0.343819 0.0 +2472 3.35 3.15 176.25 -0.839967 -0.409418 0.839975 0.385429 0.409487 -0.385428 0.0 +2473 3.35 3.25 3.75 -331.119 235.647 331.119 12776.5 -235.647 -12776.5 0.0 +2474 3.35 3.25 11.25 -210.73 43.1724 210.73 2886.81 -43.1724 -2886.81 0.0 +2475 3.35 3.25 18.75 -103.557 -28.0167 103.557 746.774 28.0167 -746.774 0.0 +2476 3.35 3.25 26.25 -36.8542 -24.6146 36.8541 147.416 24.6146 -147.416 0.0 +2477 3.35 3.25 33.75 -8.31772 -7.63126 8.31767 17.7578 7.6313 -17.7578 0.0 +2478 3.35 3.25 41.25 -0.927756 -0.474989 0.927739 1.25145 0.474959 -1.25143 0.0 +2479 3.35 3.25 48.75 -0.171876 0.182322 0.171929 0.229436 -0.182338 -0.229375 0.0 +2480 3.35 3.25 56.25 -0.173447 -0.00784342 0.173479 -0.0821736 0.00784618 0.0821739 0.0 +2481 3.35 3.25 63.75 -0.109125 0.0713448 0.109065 -0.190602 -0.071458 0.190586 0.0 +2482 3.35 3.25 71.25 -0.051811 0.125665 0.0517963 -0.170553 -0.125602 0.170563 0.0 +2483 3.35 3.25 78.75 0.0349192 0.107932 -0.0348983 -0.12797 -0.107897 0.127947 0.0 +2484 3.35 3.25 86.25 0.109977 0.0525243 -0.109978 -0.0975017 -0.0525561 0.0974949 0.0 +2485 3.35 3.25 93.75 0.133592 0.00564846 -0.133572 -0.079523 -0.0054719 0.0795129 0.0 +2486 3.35 3.25 101.25 0.13514 0.0218498 -0.135139 -0.068635 -0.0218243 0.0686367 0.0 +2487 3.35 3.25 108.75 0.125808 0.0847814 -0.125742 -0.0608821 -0.0845929 0.0608698 0.0 +2488 3.35 3.25 116.25 0.0859804 0.127099 -0.0859118 -0.046674 -0.12691 0.0466421 0.0 +2489 3.35 3.25 123.75 0.0240101 0.116896 -0.0240258 -0.0218336 -0.116907 0.0218839 0.0 +2490 3.35 3.25 131.25 -0.0259337 0.0728231 0.0260029 0.00618536 -0.0729523 -0.00609409 0.0 +2491 3.35 3.25 138.75 -0.0524477 0.0198607 0.0523403 0.031086 -0.019903 -0.0310656 0.0 +2492 3.35 3.25 146.25 -0.0771902 -0.0394305 0.0771127 0.0560935 0.0392944 -0.0560811 0.0 +2493 3.35 3.25 153.75 -0.125327 -0.115249 0.125381 0.0868502 0.11537 -0.0868962 0.0 +2494 3.35 3.25 161.25 -0.197635 -0.207122 0.19763 0.12226 0.207294 -0.122357 0.0 +2495 3.35 3.25 168.75 -0.27075 -0.295144 0.270796 0.154148 0.295239 -0.154149 0.0 +2496 3.35 3.25 176.25 -0.316454 -0.349799 0.316406 0.172999 0.349655 -0.172891 0.0 +2497 3.35 3.35 3.75 21.6477 545.28 -21.6477 11815.8 -545.28 -11815.8 0.0 +2498 3.35 3.35 11.25 0.173729 218.755 -0.173719 2394.74 -218.755 -2394.74 0.0 +2499 3.35 3.35 18.75 -9.53806 48.3705 9.53809 598.087 -48.3705 -598.087 0.0 +2500 3.35 3.35 26.25 -7.66274 -1.12322 7.66276 113.819 1.12321 -113.819 0.0 +2501 3.35 3.35 33.75 -2.74384 -3.33129 2.74384 12.9293 3.33125 -12.9293 0.0 +2502 3.35 3.35 41.25 -0.346706 -0.421196 0.346694 0.581284 0.421155 -0.581292 0.0 +2503 3.35 3.35 48.75 -0.0597258 -0.052617 0.0597015 0.0549515 0.0526707 -0.0549747 0.0 +2504 3.35 3.35 56.25 -0.126882 -0.137188 0.126857 0.0379118 0.137277 -0.0378934 0.0 +2505 3.35 3.35 63.75 -0.109892 -0.0878689 0.109868 0.00253737 0.0878685 -0.00255598 0.0 +2506 3.35 3.35 71.25 -0.0980488 -0.073463 0.0980418 -0.0105894 0.0734524 0.0105771 0.0 +2507 3.35 3.35 78.75 -0.0669262 -0.0528742 0.0669078 -0.0108983 0.0530139 0.0109302 0.0 +2508 3.35 3.35 86.25 -0.0219711 -0.0291652 0.0219318 -0.0154295 0.0291951 0.0154292 0.0 +2509 3.35 3.35 93.75 0.00146699 -0.0207303 -0.00146179 -0.0140867 0.020679 0.0140912 0.0 +2510 3.35 3.35 101.25 0.0168709 0.00290498 -0.0169225 -0.00898105 -0.00281588 0.00896964 0.0 +2511 3.35 3.35 108.75 0.0340663 0.0389815 -0.0340623 -0.0103442 -0.039102 0.0103711 0.0 +2512 3.35 3.35 116.25 0.0352042 0.0499497 -0.0351821 -0.0111656 -0.0499387 0.0111689 0.0 +2513 3.35 3.35 123.75 0.0178821 0.0273981 -0.0178368 -0.0038908 -0.0275323 0.00391568 0.0 +2514 3.35 3.35 131.25 0.00245117 -0.00157526 -0.00237029 0.00543782 0.0017713 -0.00545999 0.0 +2515 3.35 3.35 138.75 -0.000452681 -0.0169013 0.000469283 0.00962862 0.0169401 -0.00965926 0.0 +2516 3.35 3.35 146.25 -0.000710544 -0.0221597 0.000754182 0.0101186 0.0223253 -0.0102137 0.0 +2517 3.35 3.35 153.75 -0.0111111 -0.0323046 0.011189 0.0113797 0.0322223 -0.0112957 0.0 +2518 3.35 3.35 161.25 -0.0318368 -0.0542513 0.0318153 0.0143177 0.0540301 -0.014212 0.0 +2519 3.35 3.35 168.75 -0.0531774 -0.0809936 0.0531282 0.0170487 0.0810135 -0.0171249 0.0 +2520 3.35 3.35 176.25 -0.0660009 -0.0992697 0.0659877 0.01838 0.0992028 -0.0183637 0.0 +2521 3.35 3.45 3.75 264.52 547.577 -264.52 6202.93 -547.577 -6202.93 0.0 +2522 3.35 3.45 11.25 146.664 252.974 -146.664 1327.09 -252.974 -1327.09 0.0 +2523 3.35 3.45 18.75 55.5979 76.7316 -55.5979 320.33 -76.7316 -320.33 0.0 +2524 3.35 3.45 26.25 12.0322 12.2347 -12.0322 58.3259 -12.2346 -58.3259 0.0 +2525 3.35 3.45 33.75 0.596069 0.246217 -0.596031 6.50975 -0.246209 -6.50972 0.0 +2526 3.35 3.45 41.25 -0.174085 -0.0773709 0.174074 0.316004 0.0773448 -0.316022 0.0 +2527 3.35 3.45 48.75 -0.00445633 -0.0860244 0.00448977 0.0121395 0.0860192 -0.0120971 0.0 +2528 3.35 3.45 56.25 -0.0477545 -0.104883 0.0478083 0.0286837 0.104818 -0.0286912 0.0 +2529 3.35 3.45 63.75 -0.0332506 -0.0586084 0.0333016 0.00627557 0.0586119 -0.0062805 0.0 +2530 3.35 3.45 71.25 -0.0281034 -0.0608434 0.0280864 -0.00101144 0.0608456 0.00103223 0.0 +2531 3.35 3.45 78.75 -0.0318181 -0.0457338 0.0317996 0.00287139 0.0457793 -0.00287648 0.0 +2532 3.35 3.45 86.25 -0.0190638 -0.0189326 0.0190873 -0.00282309 0.0188606 0.00282802 0.0 +2533 3.35 3.45 93.75 -0.00845602 -0.00564765 0.00846357 -0.00258802 0.00569123 0.00258276 0.0 +2534 3.35 3.45 101.25 -0.000108637 0.0104483 0.000114753 0.00269483 -0.0103655 -0.00269193 0.0 +2535 3.35 3.45 108.75 0.0096153 0.0272037 -0.00961347 0.00262296 -0.0272254 -0.00260619 0.0 +2536 3.35 3.45 116.25 0.00852246 0.0258295 -0.00856241 0.0019054 -0.0259022 -0.00189501 0.0 +2537 3.35 3.45 123.75 -0.00485077 0.0100252 0.00491377 0.00479164 -0.010035 -0.00474465 0.0 +2538 3.35 3.45 131.25 -0.0151032 -0.00124015 0.0150869 0.00590864 0.00128885 -0.00595605 0.0 +2539 3.35 3.45 138.75 -0.0116773 0.000794051 0.0116531 0.00155451 -0.000693976 -0.00161011 0.0 +2540 3.35 3.45 146.25 0.000951708 0.00984726 -0.000976147 -0.00547841 -0.00985363 0.00546737 0.0 +2541 3.35 3.45 153.75 0.0141348 0.0178974 -0.0141348 -0.0120161 -0.0179225 0.0120171 0.0 +2542 3.35 3.45 161.25 0.024418 0.0223568 -0.0244107 -0.0180532 -0.022375 0.0180171 0.0 +2543 3.35 3.45 168.75 0.0321657 0.0245203 -0.0321044 -0.0239933 -0.0245871 0.0240198 0.0 +2544 3.35 3.45 176.25 0.0366433 0.0254514 -0.0366767 -0.0281044 -0.0255168 0.0281336 0.0 +2545 3.35 3.55 3.75 212.112 270.322 -212.112 1633.44 -270.322 -1633.44 0.0 +2546 3.35 3.55 11.25 122.019 134.508 -122.019 394.591 -134.508 -394.591 0.0 +2547 3.35 3.55 18.75 47.7974 44.519 -47.7974 89.0516 -44.519 -89.0516 0.0 +2548 3.35 3.55 26.25 11.0171 8.96418 -11.0171 14.3465 -8.96418 -14.3466 0.0 +2549 3.35 3.55 33.75 0.785538 1.00667 -0.785533 1.3707 -1.00666 -1.37071 0.0 +2550 3.35 3.55 41.25 -0.100275 0.111814 0.100273 0.063653 -0.111807 -0.0636804 0.0 +2551 3.35 3.55 48.75 0.0358723 -0.0504078 -0.0358729 0.0207167 0.0504272 -0.0207188 0.0 +2552 3.35 3.55 56.25 -0.0107991 -0.0545945 0.0108077 0.0260469 0.0545759 -0.0260665 0.0 +2553 3.35 3.55 63.75 -0.0137965 -0.0162173 0.01382 0.00310984 0.0162029 -0.00312469 0.0 +2554 3.35 3.55 71.25 -0.00443791 -0.0176794 0.00444316 -0.0030039 0.0176744 0.00300773 0.0 +2555 3.35 3.55 78.75 -0.00661178 -0.0194646 0.00662503 -0.000183672 0.0194799 0.000190292 0.0 +2556 3.35 3.55 86.25 -0.0044624 -0.0145146 0.00445811 -0.00308715 0.0145483 0.00308949 0.0 +2557 3.35 3.55 93.75 -0.00201713 -0.0103082 0.00203467 -0.0034837 0.0103487 0.00348302 0.0 +2558 3.35 3.55 101.25 0.000612684 -0.00214047 -0.000633647 -0.00170294 0.00208873 0.00170816 0.0 +2559 3.35 3.55 108.75 0.00492679 0.00544074 -0.00492725 -0.000964504 -0.00547196 0.000980009 0.0 +2560 3.35 3.55 116.25 0.00552459 0.00494329 -0.00551079 0.00128236 -0.00490754 -0.00128794 0.0 +2561 3.35 3.55 123.75 0.00248381 -0.000309276 -0.00248587 0.00443651 0.000330766 -0.00443577 0.0 +2562 3.35 3.55 131.25 0.00307595 -0.00427668 -0.00308807 0.00457978 0.00431048 -0.00460838 0.0 +2563 3.35 3.55 138.75 0.0100829 -0.00649667 -0.0100649 0.00162916 0.00646752 -0.00160639 0.0 +2564 3.35 3.55 146.25 0.0183636 -0.0087324 -0.0183591 -0.00101933 0.00878923 0.000998688 0.0 +2565 3.35 3.55 153.75 0.0223417 -0.00978813 -0.0223341 -0.00163428 0.00977234 0.00164318 0.0 +2566 3.35 3.55 161.25 0.0213234 -0.00730229 -0.0213443 -0.0014192 0.00724781 0.00144804 0.0 +2567 3.35 3.55 168.75 0.0183265 -0.00180711 -0.0183314 -0.00178155 0.00182466 0.00177075 0.0 +2568 3.35 3.55 176.25 0.0161793 0.00277081 -0.0161889 -0.00245834 -0.00278613 0.00245868 0.0 +2569 3.35 3.65 3.75 34.2993 31.2111 -34.2993 99.1827 -31.2111 -99.1827 0.0 +2570 3.35 3.65 11.25 20.1073 16.1249 -20.1073 25.0862 -16.1249 -25.0862 0.0 +2571 3.35 3.65 18.75 7.81038 5.38483 -7.81038 4.29487 -5.38483 -4.29487 0.0 +2572 3.35 3.65 26.25 1.72232 1.10266 -1.72232 0.220387 -1.10265 -0.220388 0.0 +2573 3.35 3.65 33.75 0.0886792 0.151586 -0.0886799 -0.0820027 -0.151586 0.0820019 0.0 +2574 3.35 3.65 41.25 -0.0173171 0.0309048 0.0173154 -0.015518 -0.0309058 0.0155196 0.0 +2575 3.35 3.65 48.75 0.0101661 -0.00286499 -0.0101673 0.00763683 0.00286567 -0.00763753 0.0 +2576 3.35 3.65 56.25 -0.002689 -0.00624694 0.00268935 0.0083081 0.00624704 -0.00830852 0.0 +2577 3.35 3.65 63.75 -0.00312949 0.000414859 0.00313187 0.00248767 -0.000415121 -0.00248719 0.0 +2578 3.35 3.65 71.25 0.00176759 0.00183364 -0.00176593 0.000912355 -0.00183059 -0.000912314 0.0 +2579 3.35 3.65 78.75 0.00272836 0.00157348 -0.00272759 0.00117466 -0.00157332 -0.00117415 0.0 +2580 3.35 3.65 86.25 0.00159309 0.000928734 -0.00159386 0.000236076 -0.000929755 -0.000236263 0.0 +2581 3.35 3.65 93.75 -8.27674e-05 0.000144333 8.23358e-05 -0.00112934 -0.000145183 0.00112914 0.0 +2582 3.35 3.65 101.25 -0.000947847 0.000224482 0.00094892 -0.00225916 -0.000225888 0.00225973 0.0 +2583 3.35 3.65 108.75 -0.000863792 0.000432852 0.000864512 -0.00237019 -0.000431765 0.0023699 0.0 +2584 3.35 3.65 116.25 -0.000961541 -5.64864e-05 0.000960868 -0.0011264 6.07289e-05 0.00112608 0.0 +2585 3.35 3.65 123.75 -0.00127243 -0.000805706 0.0012707 0.000252729 0.000806025 -0.000253886 0.0 +2586 3.35 3.65 131.25 -0.000913381 -0.00130653 0.000910966 0.000474326 0.00130583 -0.000474541 0.0 +2587 3.35 3.65 138.75 -5.53154e-05 -0.00154588 5.78325e-05 -0.000286174 0.00155054 0.000285032 0.0 +2588 3.35 3.65 146.25 -6.51777e-05 -0.00124019 6.5744e-05 -0.000995048 0.00124163 0.000994467 0.0 +2589 3.35 3.65 153.75 -0.0019038 0.00032226 0.00190333 -0.00107275 -0.000320901 0.00107123 0.0 +2590 3.35 3.65 161.25 -0.00517932 0.00335224 0.00517862 -0.000703318 -0.00335729 0.000705883 0.0 +2591 3.35 3.65 168.75 -0.00853589 0.00691614 0.00853695 -0.000307448 -0.00691271 0.000304936 0.0 +2592 3.35 3.65 176.25 -0.0106065 0.00934073 0.0106054 -0.000100664 -0.0093421 0.000101267 0.0 +2593 3.45 2.55 3.75 -306.256 -630.26 306.256 712.027 630.26 -712.027 0.0 +2594 3.45 2.55 11.25 -241.643 -460.837 241.643 436.705 460.837 -436.705 0.0 +2595 3.45 2.55 18.75 -163.644 -227.704 163.644 196.914 227.704 -196.914 0.0 +2596 3.45 2.55 26.25 -109.293 -33.3416 109.293 89.2043 33.3416 -89.2043 0.0 +2597 3.45 2.55 33.75 -79.3847 79.4725 79.3847 51.6528 -79.4725 -51.6528 0.0 +2598 3.45 2.55 41.25 -58.4527 119.272 58.4527 27.3787 -119.272 -27.3787 0.0 +2599 3.45 2.55 48.75 -36.2063 116.335 36.2063 1.24536 -116.335 -1.24536 0.0 +2600 3.45 2.55 56.25 -12.877 98.7088 12.877 -21.3417 -98.7088 21.3417 0.0 +2601 3.45 2.55 63.75 6.39264 81.7834 -6.39265 -34.2469 -81.7834 34.2469 0.0 +2602 3.45 2.55 71.25 17.6707 68.9207 -17.6707 -36.3618 -68.9207 36.3618 0.0 +2603 3.45 2.55 78.75 20.7496 57.5203 -20.7496 -30.7183 -57.5203 30.7183 0.0 +2604 3.45 2.55 86.25 18.6942 44.7959 -18.6942 -22.1495 -44.7959 22.1495 0.0 +2605 3.45 2.55 93.75 15.7399 30.0692 -15.7399 -14.7587 -30.0692 14.7587 0.0 +2606 3.45 2.55 101.25 14.9561 14.1711 -14.9561 -10.3261 -14.1711 10.3261 0.0 +2607 3.45 2.55 108.75 17.1133 -1.75859 -17.1132 -8.43042 1.75863 8.43042 0.0 +2608 3.45 2.55 116.25 21.1653 -16.7758 -21.1653 -7.6838 16.7758 7.6838 0.0 +2609 3.45 2.55 123.75 25.5091 -30.1056 -25.509 -6.89494 30.1057 6.89493 0.0 +2610 3.45 2.55 131.25 28.9655 -41.1155 -28.9654 -5.54039 41.1155 5.54038 0.0 +2611 3.45 2.55 138.75 31.0793 -49.4383 -31.0794 -3.65858 49.4383 3.65857 0.0 +2612 3.45 2.55 146.25 31.9503 -55.0945 -31.9503 -1.54808 55.0945 1.54807 0.0 +2613 3.45 2.55 153.75 31.9458 -58.4765 -31.9458 0.46791 58.4765 -0.467925 0.0 +2614 3.45 2.55 161.25 31.4914 -60.2005 -31.4914 2.14501 60.2005 -2.14503 0.0 +2615 3.45 2.55 168.75 30.9607 -60.9133 -30.9607 3.33031 60.9133 -3.3303 0.0 +2616 3.45 2.55 176.25 30.6245 -61.1297 -30.6245 3.94075 61.1298 -3.94076 0.0 +2617 3.45 2.65 3.75 -410.404 -684.119 410.404 1124.97 684.119 -1124.97 0.0 +2618 3.45 2.65 11.25 -315.445 -504.168 315.445 663.12 504.168 -663.12 0.0 +2619 3.45 2.65 18.75 -200.158 -265.393 200.158 285.214 265.393 -285.214 0.0 +2620 3.45 2.65 26.25 -117.759 -74.4043 117.759 118.865 74.4044 -118.865 0.0 +2621 3.45 2.65 33.75 -72.7391 32.0266 72.7391 62.0115 -32.0266 -62.0115 0.0 +2622 3.45 2.65 41.25 -46.6794 69.0359 46.6794 32.6288 -69.0359 -32.6288 0.0 +2623 3.45 2.65 48.75 -25.0296 68.799 25.0296 6.85355 -68.799 -6.85356 0.0 +2624 3.45 2.65 56.25 -4.70437 57.3573 4.70435 -12.9243 -57.3573 12.9243 0.0 +2625 3.45 2.65 63.75 11.3837 47.5257 -11.3838 -22.9609 -47.5257 22.9609 0.0 +2626 3.45 2.65 71.25 20.5482 41.3831 -20.5482 -23.9869 -41.3831 23.9869 0.0 +2627 3.45 2.65 78.75 22.8085 36.193 -22.8085 -19.5196 -36.193 19.5196 0.0 +2628 3.45 2.65 86.25 20.6545 29.4327 -20.6545 -13.6165 -29.4327 13.6165 0.0 +2629 3.45 2.65 93.75 17.4317 20.6221 -17.4318 -9.11551 -20.6221 9.11551 0.0 +2630 3.45 2.65 101.25 15.4934 10.6053 -15.4934 -6.83936 -10.6052 6.83936 0.0 +2631 3.45 2.65 108.75 15.3634 0.398853 -15.3634 -6.08122 -0.398839 6.08122 0.0 +2632 3.45 2.65 116.25 16.2491 -9.23221 -16.2491 -5.71107 9.23223 5.71106 0.0 +2633 3.45 2.65 123.75 17.0991 -17.6958 -17.0991 -4.98277 17.6958 4.98277 0.0 +2634 3.45 2.65 131.25 17.2969 -24.5169 -17.2969 -3.71694 24.5169 3.71693 0.0 +2635 3.45 2.65 138.75 16.7536 -29.4367 -16.7536 -2.09401 29.4367 2.09401 0.0 +2636 3.45 2.65 146.25 15.6864 -32.5095 -15.6864 -0.393538 32.5095 0.393535 0.0 +2637 3.45 2.65 153.75 14.3972 -34.0775 -14.3972 1.15395 34.0775 -1.15396 0.0 +2638 3.45 2.65 161.25 13.1634 -34.6385 -13.1634 2.40176 34.6385 -2.40176 0.0 +2639 3.45 2.65 168.75 12.2071 -34.6906 -12.2071 3.26815 34.6906 -3.26815 0.0 +2640 3.45 2.65 176.25 11.6868 -34.6153 -11.6868 3.7106 34.6154 -3.7106 0.0 +2641 3.45 2.75 3.75 -497.255 -677 497.255 1652.99 677 -1652.99 0.0 +2642 3.45 2.75 11.25 -373.691 -495.677 373.691 915.601 495.677 -915.601 0.0 +2643 3.45 2.75 18.75 -225.553 -263.706 225.553 365.966 263.706 -365.966 0.0 +2644 3.45 2.75 26.25 -119.766 -85.9838 119.766 136.334 85.9838 -136.334 0.0 +2645 3.45 2.75 33.75 -63.267 7.86172 63.267 62.4019 -7.86172 -62.4019 0.0 +2646 3.45 2.75 41.25 -34.7214 38.5117 34.7215 30.9646 -38.5117 -30.9646 0.0 +2647 3.45 2.75 48.75 -15.6402 38.6905 15.6402 7.75474 -38.6905 -7.75474 0.0 +2648 3.45 2.75 56.25 0.200898 31.3646 -0.200906 -8.25822 -31.3646 8.25823 0.0 +2649 3.45 2.75 63.75 12.1025 26.2015 -12.1025 -15.3813 -26.2016 15.3813 0.0 +2650 3.45 2.75 71.25 18.645 23.9679 -18.645 -15.4998 -23.9679 15.4998 0.0 +2651 3.45 2.75 78.75 20.0366 22.0995 -20.0365 -12.0647 -22.0994 12.0647 0.0 +2652 3.45 2.75 86.25 18.0975 18.6666 -18.0975 -8.18733 -18.6667 8.18733 0.0 +2653 3.45 2.75 93.75 15.203 13.548 -15.2031 -5.61947 -13.548 5.61947 0.0 +2654 3.45 2.75 101.25 12.9731 7.59374 -12.9732 -4.55604 -7.59372 4.55604 0.0 +2655 3.45 2.75 108.75 11.7095 1.61177 -11.7095 -4.26673 -1.61172 4.26671 0.0 +2656 3.45 2.75 116.25 10.8678 -3.90594 -10.8678 -3.95972 3.9059 3.95974 0.0 +2657 3.45 2.75 123.75 9.86364 -8.62299 -9.86364 -3.25525 8.62305 3.25522 0.0 +2658 3.45 2.75 131.25 8.48939 -12.2677 -8.48935 -2.17621 12.2677 2.1762 0.0 +2659 3.45 2.75 138.75 6.8561 -14.7058 -6.85612 -0.925779 14.7058 0.925792 0.0 +2660 3.45 2.75 146.25 5.17617 -16.0173 -5.17617 0.29668 16.0172 -0.296656 0.0 +2661 3.45 2.75 153.75 3.62928 -16.4706 -3.62927 1.36272 16.4706 -1.36274 0.0 +2662 3.45 2.75 161.25 2.34356 -16.418 -2.34357 2.20438 16.4181 -2.2044 0.0 +2663 3.45 2.75 168.75 1.41823 -16.1869 -1.41824 2.78491 16.1869 -2.7849 0.0 +2664 3.45 2.75 176.25 0.93231 -16.012 -0.932328 3.08139 16.012 -3.0814 0.0 +2665 3.45 2.85 3.75 -548.003 -614.565 548.003 2304.07 614.565 -2304.07 0.0 +2666 3.45 2.85 11.25 -403.385 -446.114 403.385 1173.83 446.114 -1173.83 0.0 +2667 3.45 2.85 18.75 -233.959 -236.004 233.959 430.61 236.004 -430.61 0.0 +2668 3.45 2.85 26.25 -114.291 -80.069 114.291 141.231 80.069 -141.231 0.0 +2669 3.45 2.85 33.75 -52.1051 -2.02399 52.1051 55.1217 2.02396 -55.1216 0.0 +2670 3.45 2.85 41.25 -24.0012 21.2002 24.0012 25.0552 -21.2002 -25.0552 0.0 +2671 3.45 2.85 48.75 -8.75879 20.9185 8.75874 6.24251 -20.9185 -6.2425 0.0 +2672 3.45 2.85 56.25 2.17439 16.3646 -2.17443 -5.56933 -16.3647 5.56933 0.0 +2673 3.45 2.85 63.75 9.87494 14.0522 -9.87497 -10.1202 -14.0522 10.1202 0.0 +2674 3.45 2.85 71.25 13.9611 13.6826 -13.9611 -9.68958 -13.6825 9.68959 0.0 +2675 3.45 2.85 78.75 14.7195 13.1469 -14.7196 -7.20381 -13.1468 7.20382 0.0 +2676 3.45 2.85 86.25 13.2825 11.2688 -13.2825 -4.80907 -11.2688 4.80907 0.0 +2677 3.45 2.85 93.75 11.1137 8.28982 -11.1137 -3.43822 -8.28984 3.43822 0.0 +2678 3.45 2.85 101.25 9.19959 4.99293 -9.19962 -2.96627 -4.99292 2.96627 0.0 +2679 3.45 2.85 108.75 7.69011 1.9132 -7.69008 -2.80506 -1.91323 2.80506 0.0 +2680 3.45 2.85 116.25 6.26738 -0.754121 -6.26738 -2.48465 0.754107 2.48465 0.0 +2681 3.45 2.85 123.75 4.69302 -2.92053 -4.69298 -1.87011 2.92052 1.87014 0.0 +2682 3.45 2.85 131.25 3.00043 -4.49316 -3.00046 -1.0617 4.4931 1.0617 0.0 +2683 3.45 2.85 138.75 1.35896 -5.43071 -1.35895 -0.214639 5.4307 0.21465 0.0 +2684 3.45 2.85 146.25 -0.0975721 -5.80953 0.0975683 0.564043 5.80952 -0.564042 0.0 +2685 3.45 2.85 153.75 -1.31554 -5.80487 1.31554 1.22538 5.80502 -1.22545 0.0 +2686 3.45 2.85 161.25 -2.27717 -5.61838 2.27719 1.74807 5.6184 -1.74807 0.0 +2687 3.45 2.85 168.75 -2.95565 -5.41309 2.95571 2.11405 5.41315 -2.11407 0.0 +2688 3.45 2.85 176.25 -3.31048 -5.28882 3.31047 2.30378 5.2888 -2.30378 0.0 +2689 3.45 2.95 3.75 -544.922 -497.061 544.922 3078.39 497.061 -3078.39 0.0 +2690 3.45 2.95 11.25 -393.552 -362.493 393.552 1406.5 362.493 -1406.5 0.0 +2691 3.45 2.95 18.75 -221.236 -192.412 221.236 470.974 192.412 -470.974 0.0 +2692 3.45 2.95 26.25 -101.063 -66.0352 101.063 134.97 66.0352 -134.97 0.0 +2693 3.45 2.95 33.75 -40.2469 -4.86193 40.2469 43.3621 4.86195 -43.3621 0.0 +2694 3.45 2.95 41.25 -15.2898 11.6213 15.2897 17.5126 -11.6213 -17.5126 0.0 +2695 3.45 2.95 48.75 -4.33523 10.905 4.3352 4.04329 -10.905 -4.04327 0.0 +2696 3.45 2.95 56.25 2.18714 8.24837 -2.1872 -3.74017 -8.24831 3.74018 0.0 +2697 3.45 2.95 63.75 6.40955 7.51416 -6.40948 -6.31275 -7.51421 6.31275 0.0 +2698 3.45 2.95 71.25 8.60941 7.77106 -8.60947 -5.71424 -7.77112 5.71422 0.0 +2699 3.45 2.95 78.75 9.03579 7.52495 -9.03581 -4.08358 -7.52497 4.08358 0.0 +2700 3.45 2.95 86.25 8.21402 6.29483 -8.21403 -2.72405 -6.29472 2.72405 0.0 +2701 3.45 2.95 93.75 6.87838 4.54861 -6.87836 -2.03984 -4.54871 2.03984 0.0 +2702 3.45 2.95 101.25 5.55629 2.91176 -5.55627 -1.81705 -2.91174 1.81705 0.0 +2703 3.45 2.95 108.75 4.32565 1.64201 -4.32569 -1.67096 -1.6421 1.67098 0.0 +2704 3.45 2.95 116.25 3.04826 0.69376 -3.04833 -1.37414 -0.693725 1.37412 0.0 +2705 3.45 2.95 123.75 1.69501 -0.0160375 -1.69503 -0.916383 0.0161119 0.916364 0.0 +2706 3.45 2.95 131.25 0.392887 -0.501719 -0.392925 -0.394265 0.501627 0.394291 0.0 +2707 3.45 2.95 138.75 -0.724329 -0.76263 0.724304 0.105035 0.762673 -0.105085 0.0 +2708 3.45 2.95 146.25 -1.61972 -0.843823 1.61969 0.545164 0.843697 -0.545116 0.0 +2709 3.45 2.95 153.75 -2.33022 -0.828516 2.33023 0.921858 0.828524 -0.921868 0.0 +2710 3.45 2.95 161.25 -2.89222 -0.792299 2.89228 1.23178 0.792409 -1.2318 0.0 +2711 3.45 2.95 168.75 -3.30112 -0.771646 3.30113 1.45896 0.771608 -1.45895 0.0 +2712 3.45 2.95 176.25 -3.52114 -0.766502 3.52118 1.58062 0.766532 -1.5806 0.0 +2713 3.45 3.05 3.75 -475.314 -322.42 475.314 3963.8 322.42 -3963.8 0.0 +2714 3.45 3.05 11.25 -338.348 -249.248 338.348 1573.32 249.248 -1573.32 0.0 +2715 3.45 3.05 18.75 -186.445 -139.031 186.445 480.819 139.031 -480.819 0.0 +2716 3.45 3.05 26.25 -81.0201 -49.399 81.0201 120.377 49.399 -120.377 0.0 +2717 3.45 3.05 33.75 -28.6328 -5.08278 28.6327 30.5097 5.08277 -30.5097 0.0 +2718 3.45 3.05 41.25 -8.82638 6.11139 8.82637 10.4404 -6.1114 -10.4404 0.0 +2719 3.45 3.05 48.75 -1.85343 5.32625 1.85346 2.16403 -5.32623 -2.164 0.0 +2720 3.45 3.05 56.25 1.35086 3.92765 -1.35083 -2.2841 -3.92766 2.2841 0.0 +2721 3.45 3.05 63.75 3.18303 3.93111 -3.18308 -3.54526 -3.93104 3.54527 0.0 +2722 3.45 3.05 71.25 4.18326 4.23744 -4.18318 -3.05394 -4.23741 3.05394 0.0 +2723 3.45 3.05 78.75 4.49258 3.9582 -4.49266 -2.12863 -3.95825 2.12861 0.0 +2724 3.45 3.05 86.25 4.19958 3.07628 -4.19957 -1.44525 -3.07631 1.44525 0.0 +2725 3.45 3.05 93.75 3.55703 2.09269 -3.55702 -1.12965 -2.09265 1.12965 0.0 +2726 3.45 3.05 101.25 2.82082 1.42577 -2.82082 -1.00836 -1.42574 1.00835 0.0 +2727 3.45 3.05 108.75 2.05335 1.12201 -2.0533 -0.879428 -1.12204 0.879438 0.0 +2728 3.45 3.05 116.25 1.22927 1.00436 -1.22931 -0.659137 -1.00432 0.659097 0.0 +2729 3.45 3.05 123.75 0.406034 0.922498 -0.406042 -0.375131 -0.922546 0.375153 0.0 +2730 3.45 3.05 131.25 -0.296186 0.832273 0.296225 -0.0883048 -0.832251 0.0882832 0.0 +2731 3.45 3.05 138.75 -0.814568 0.737363 0.814575 0.167299 -0.7374 -0.167276 0.0 +2732 3.45 3.05 146.25 -1.18502 0.630537 1.18498 0.392395 -0.630556 -0.392405 0.0 +2733 3.45 3.05 153.75 -1.48257 0.494496 1.48259 0.5978 -0.494437 -0.597808 0.0 +2734 3.45 3.05 161.25 -1.74881 0.331167 1.74885 0.781687 -0.331182 -0.781664 0.0 +2735 3.45 3.05 168.75 -1.96879 0.175253 1.96874 0.925742 -0.175235 -0.925772 0.0 +2736 3.45 3.05 176.25 -2.0967 0.0786764 2.09672 1.00588 -0.0786713 -1.00589 0.0 +2737 3.45 3.15 3.75 -335.15 -93.6243 335.15 4919.2 93.6243 -4919.2 0.0 +2738 3.45 3.15 11.25 -239.412 -112.098 239.412 1631.97 112.098 -1631.97 0.0 +2739 3.45 3.15 18.75 -132.594 -79.3632 132.594 457.179 79.3632 -457.179 0.0 +2740 3.45 3.15 26.25 -56.3887 -32.3191 56.3887 100.818 32.3191 -100.818 0.0 +2741 3.45 3.15 33.75 -18.16 -4.51131 18.1601 19.3237 4.51132 -19.3237 0.0 +2742 3.45 3.15 41.25 -4.4854 2.78229 4.48539 5.12234 -2.78226 -5.12233 0.0 +2743 3.45 3.15 48.75 -0.65816 2.23549 0.65826 0.957979 -2.23558 -0.957965 0.0 +2744 3.45 3.15 56.25 0.506275 1.58325 -0.506256 -1.13658 -1.58328 1.13657 0.0 +2745 3.45 3.15 63.75 1.03096 1.81098 -1.03093 -1.6632 -1.811 1.66321 0.0 +2746 3.45 3.15 71.25 1.41183 2.0053 -1.4118 -1.38913 -2.00536 1.38912 0.0 +2747 3.45 3.15 78.75 1.68372 1.73689 -1.68371 -0.965934 -1.73688 0.965929 0.0 +2748 3.45 3.15 86.25 1.70752 1.16763 -1.70751 -0.682141 -1.16765 0.682142 0.0 +2749 3.45 3.15 93.75 1.49569 0.679886 -1.49564 -0.555736 -0.679951 0.555736 0.0 +2750 3.45 3.15 101.25 1.17836 0.506082 -1.17831 -0.491039 -0.506091 0.491053 0.0 +2751 3.45 3.15 108.75 0.820869 0.586875 -0.820847 -0.406929 -0.586908 0.406931 0.0 +2752 3.45 3.15 116.25 0.442639 0.726307 -0.442661 -0.282046 -0.726397 0.28205 0.0 +2753 3.45 3.15 123.75 0.104502 0.791195 -0.10453 -0.138832 -0.791224 0.138815 0.0 +2754 3.45 3.15 131.25 -0.122088 0.757803 0.122111 -0.00554787 -0.757786 0.00557081 0.0 +2755 3.45 3.15 138.75 -0.233371 0.647708 0.233317 0.11009 -0.647633 -0.110127 0.0 +2756 3.45 3.15 146.25 -0.294334 0.47602 0.294323 0.218656 -0.476048 -0.218642 0.0 +2757 3.45 3.15 153.75 -0.374289 0.252194 0.374305 0.329856 -0.252147 -0.329913 0.0 +2758 3.45 3.15 161.25 -0.492985 0.00374022 0.493045 0.439147 -0.00376578 -0.439083 0.0 +2759 3.45 3.15 168.75 -0.618588 -0.216468 0.618562 0.529275 0.216442 -0.529286 0.0 +2760 3.45 3.15 176.25 -0.699206 -0.346872 0.699206 0.580539 0.346963 -0.580578 0.0 +2761 3.45 3.25 3.75 -131.986 172.423 131.986 5807.16 -172.423 -5807.16 0.0 +2762 3.45 3.25 11.25 -106.676 37.9086 106.676 1550.79 -37.9086 -1550.79 0.0 +2763 3.45 3.25 18.75 -66.3639 -16.7646 66.364 401.081 16.7646 -401.081 0.0 +2764 3.45 3.25 26.25 -30.3473 -15.2048 30.3473 79.1321 15.2048 -79.1321 0.0 +2765 3.45 3.25 33.75 -9.59735 -3.38585 9.59735 11.2832 3.38583 -11.2832 0.0 +2766 3.45 3.25 41.25 -1.92176 0.888505 1.92175 1.94054 -0.88848 -1.94058 0.0 +2767 3.45 3.25 48.75 -0.186459 0.662911 0.186482 0.346642 -0.662898 -0.346709 0.0 +2768 3.45 3.25 56.25 0.0336511 0.376814 -0.0335823 -0.381553 -0.376846 0.381531 0.0 +2769 3.45 3.25 63.75 0.0610398 0.568743 -0.0610638 -0.568847 -0.568734 0.568857 0.0 +2770 3.45 3.25 71.25 0.191319 0.669351 -0.191358 -0.479143 -0.669399 0.479151 0.0 +2771 3.45 3.25 78.75 0.405751 0.51543 -0.405724 -0.34219 -0.515447 0.3422 0.0 +2772 3.45 3.25 86.25 0.526203 0.236753 -0.526194 -0.259964 -0.236729 0.259964 0.0 +2773 3.45 3.25 93.75 0.497209 0.0446808 -0.49719 -0.226352 -0.0447335 0.226358 0.0 +2774 3.45 3.25 101.25 0.400656 0.0545232 -0.400668 -0.204302 -0.0545018 0.204314 0.0 +2775 3.45 3.25 108.75 0.294574 0.196188 -0.294587 -0.171634 -0.196092 0.1716 0.0 +2776 3.45 3.25 116.25 0.19472 0.324411 -0.194713 -0.123137 -0.324523 0.123175 0.0 +2777 3.45 3.25 123.75 0.132272 0.361164 -0.132303 -0.0670742 -0.361206 0.0670926 0.0 +2778 3.45 3.25 131.25 0.135206 0.313195 -0.135187 -0.0147294 -0.313223 0.0147091 0.0 +2779 3.45 3.25 138.75 0.182857 0.21121 -0.182794 0.0326203 -0.211273 -0.0325507 0.0 +2780 3.45 3.25 146.25 0.217909 0.068651 -0.217902 0.0824645 -0.0686142 -0.0825051 0.0 +2781 3.45 3.25 153.75 0.198459 -0.108935 -0.198506 0.139161 0.1089 -0.139151 0.0 +2782 3.45 3.25 161.25 0.12767 -0.302368 -0.127653 0.197311 0.302337 -0.197299 0.0 +2783 3.45 3.25 168.75 0.0427846 -0.472116 -0.0427358 0.245295 0.472357 -0.245467 0.0 +2784 3.45 3.25 176.25 -0.0129573 -0.572229 0.0129579 0.272254 0.572361 -0.272348 0.0 +2785 3.45 3.35 3.75 108.302 421.496 -108.302 5958.83 -421.496 -5958.83 0.0 +2786 3.45 3.35 11.25 41.2462 175.982 -41.2462 1273.31 -175.982 -1273.31 0.0 +2787 3.45 3.35 18.75 3.01038 41.906 -3.0104 305.247 -41.906 -305.247 0.0 +2788 3.45 3.35 26.25 -6.1326 1.47736 6.13263 54.6726 -1.47737 -54.6726 0.0 +2789 3.45 3.35 33.75 -3.31533 -1.47586 3.31531 6.12001 1.47584 -6.12 0.0 +2790 3.45 3.35 41.25 -0.645403 0.0817823 0.645396 0.522618 -0.081765 -0.52267 0.0 +2791 3.45 3.35 48.75 -0.0508309 0.0548983 0.0508385 0.088753 -0.054907 -0.0887145 0.0 +2792 3.45 3.35 56.25 -0.086444 -0.0749055 0.0864092 -0.0334013 0.0748983 0.0334289 0.0 +2793 3.45 3.35 63.75 -0.118584 0.00885222 0.118561 -0.0912918 -0.00885908 0.0913019 0.0 +2794 3.45 3.35 71.25 -0.0737239 0.0593776 0.0737854 -0.088756 -0.0594375 0.0887584 0.0 +2795 3.45 3.35 78.75 0.036563 0.0346896 -0.0365392 -0.0646539 -0.0346542 0.0646679 0.0 +2796 3.45 3.35 86.25 0.115213 -0.0407592 -0.115217 -0.0589973 0.0407232 0.0589937 0.0 +2797 3.45 3.35 93.75 0.121241 -0.0943378 -0.121253 -0.0623952 0.0942932 0.0623931 0.0 +2798 3.45 3.35 101.25 0.105666 -0.0629274 -0.105684 -0.0638035 0.0629433 0.0637916 0.0 +2799 3.45 3.35 108.75 0.100399 0.0188446 -0.100413 -0.0630221 -0.0188428 0.0629937 0.0 +2800 3.45 3.35 116.25 0.101209 0.0751847 -0.101172 -0.0564777 -0.0751112 0.0564679 0.0 +2801 3.45 3.35 123.75 0.114923 0.0786105 -0.114898 -0.0437503 -0.0785564 0.0437357 0.0 +2802 3.45 3.35 131.25 0.152279 0.0502791 -0.152333 -0.0294588 -0.050311 0.0294693 0.0 +2803 3.45 3.35 138.75 0.197497 0.0112211 -0.197509 -0.0146718 -0.0112948 0.0147128 0.0 +2804 3.45 3.35 146.25 0.218165 -0.0385802 -0.2182 0.00342743 0.0385741 -0.00344245 0.0 +2805 3.45 3.35 153.75 0.198221 -0.105349 -0.198196 0.0247121 0.105367 -0.024701 0.0 +2806 3.45 3.35 161.25 0.149784 -0.1847 -0.149761 0.0445218 0.184701 -0.0445184 0.0 +2807 3.45 3.35 168.75 0.0992213 -0.258039 -0.0992126 0.0582518 0.258116 -0.0583085 0.0 +2808 3.45 3.35 176.25 0.06856 -0.302331 -0.0685837 0.0647053 0.302274 -0.0646862 0.0 +2809 3.45 3.45 3.75 249.963 447.743 -249.963 3664.97 -447.743 -3664.97 0.0 +2810 3.45 3.45 11.25 130.312 207.993 -130.312 676.249 -207.993 -676.249 0.0 +2811 3.45 3.45 18.75 45.7667 65.0303 -45.7667 147.519 -65.0303 -147.519 0.0 +2812 3.45 3.45 26.25 8.62768 11.3441 -8.62769 23.4633 -11.3441 -23.4633 0.0 +2813 3.45 3.45 33.75 0.110016 0.590793 -0.109988 2.30758 -0.590787 -2.3076 0.0 +2814 3.45 3.45 41.25 -0.153757 -0.0039627 0.153717 0.133259 0.00394772 -0.133226 0.0 +2815 3.45 3.45 48.75 -0.0153495 -0.0393026 0.0153515 0.00700061 0.0393356 -0.00698054 0.0 +2816 3.45 3.45 56.25 -0.0482726 -0.073912 0.0483149 0.0251197 0.0739223 -0.0251188 0.0 +2817 3.45 3.45 63.75 -0.0289355 -0.0533479 0.0289021 0.00597862 0.053373 -0.00597884 0.0 +2818 3.45 3.45 71.25 -0.0187811 -0.0391984 0.018746 0.000512192 0.039198 -0.000501842 0.0 +2819 3.45 3.45 78.75 -0.00856621 -0.0176478 0.00859924 0.00690296 0.0177056 -0.00690308 0.0 +2820 3.45 3.45 86.25 0.00371125 -0.0135792 -0.00372377 0.00136037 0.0136089 -0.0013601 0.0 +2821 3.45 3.45 93.75 0.00477561 -0.0238325 -0.00478562 -0.00283706 0.0238591 0.00283968 0.0 +2822 3.45 3.45 101.25 0.00818656 -0.0174538 -0.00812902 -0.00263731 0.017444 0.00264151 0.0 +2823 3.45 3.45 108.75 0.0169419 0.00155597 -0.0169639 -0.00543721 -0.00155808 0.00543126 0.0 +2824 3.45 3.45 116.25 0.0195788 0.0116859 -0.0195369 -0.00999959 -0.0117365 0.0100136 0.0 +2825 3.45 3.45 123.75 0.0183927 0.0116238 -0.0183971 -0.013227 -0.011666 0.0132448 0.0 +2826 3.45 3.45 131.25 0.0233808 0.0121941 -0.0234038 -0.0149326 -0.0122148 0.0149266 0.0 +2827 3.45 3.45 138.75 0.0316355 0.0161105 -0.0316222 -0.0142598 -0.0161126 0.0142499 0.0 +2828 3.45 3.45 146.25 0.0319972 0.0182352 -0.0319926 -0.0107349 -0.018201 0.0107262 0.0 +2829 3.45 3.45 153.75 0.0212885 0.0151617 -0.0213003 -0.0072284 -0.0151286 0.00721379 0.0 +2830 3.45 3.45 161.25 0.00710262 0.00875975 -0.00709702 -0.00763624 -0.00879653 0.00766868 0.0 +2831 3.45 3.45 168.75 -0.0026401 0.00265877 0.00265377 -0.0121265 -0.00270055 0.0121613 0.0 +2832 3.45 3.45 176.25 -0.00643116 -0.000726218 0.00644015 -0.0165154 0.000842039 0.0164549 0.0 +2833 3.45 3.55 3.75 176.165 231.846 -176.165 1002.13 -231.846 -1002.13 0.0 +2834 3.45 3.55 11.25 95.7124 114.358 -95.7124 175.442 -114.358 -175.442 0.0 +2835 3.45 3.55 18.75 35.3486 38.8706 -35.3486 30.2113 -38.8706 -30.2113 0.0 +2836 3.45 3.55 26.25 7.45817 8.24142 -7.45818 2.93187 -8.24142 -2.93187 0.0 +2837 3.45 3.55 33.75 0.442038 0.937077 -0.442023 0.16053 -0.937083 -0.160524 0.0 +2838 3.45 3.55 41.25 -0.036135 0.0544695 0.0361478 0.0475514 -0.0544678 -0.0475693 0.0 +2839 3.45 3.55 48.75 0.0114763 -0.0262494 -0.0114589 0.0137087 0.0262505 -0.0137065 0.0 +2840 3.45 3.55 56.25 -0.0247279 -0.0151853 0.0247269 0.0138833 0.0151975 -0.0138936 0.0 +2841 3.45 3.55 63.75 -0.00534614 0.000359977 0.00535626 -0.000883675 -0.000355567 0.000884282 0.0 +2842 3.45 3.55 71.25 0.0021508 -0.00431124 -0.00217205 -0.00167595 0.00430117 0.00167024 0.0 +2843 3.45 3.55 78.75 -0.00618242 -0.0011063 0.00617677 0.00219776 0.00111944 -0.00219769 0.0 +2844 3.45 3.55 86.25 -0.00864154 0.00382556 0.00863024 -0.000880014 -0.00382877 0.000881011 0.0 +2845 3.45 3.55 93.75 -0.00688417 0.00308196 0.00688064 -0.000591138 -0.00307945 0.000591269 0.0 +2846 3.45 3.55 101.25 -0.00277733 0.00250811 0.00278446 0.00339576 -0.00248041 -0.00339897 0.0 +2847 3.45 3.55 108.75 9.6645e-05 0.00292517 -9.27955e-05 0.00533124 -0.00297869 -0.00532125 0.0 +2848 3.45 3.55 116.25 -0.00279109 0.00312423 0.0027777 0.004826 -0.00313043 -0.00482587 0.0 +2849 3.45 3.55 123.75 -0.007852 0.00420337 0.00785189 0.00337755 -0.00423422 -0.00336561 0.0 +2850 3.45 3.55 131.25 -0.00899665 0.00525366 0.00898163 0.00211415 -0.00526556 -0.00211688 0.0 +2851 3.45 3.55 138.75 -0.00658818 0.00353401 0.00658935 0.00247574 -0.00351467 -0.00247806 0.0 +2852 3.45 3.55 146.25 -0.00472251 -0.000274464 0.0047137 0.00454554 0.000265355 -0.00453667 0.0 +2853 3.45 3.55 153.75 -0.00408631 -0.00145214 0.00408205 0.00601461 0.00145164 -0.0060113 0.0 +2854 3.45 3.55 161.25 -0.00213812 0.00336809 0.00214451 0.0045329 -0.00336917 -0.00453833 0.0 +2855 3.45 3.55 168.75 0.002039 0.0122448 -0.00204369 0.000537346 -0.0122471 -0.000536574 0.0 +2856 3.45 3.55 176.25 0.00576826 0.0191805 -0.00579318 -0.00289312 -0.0192316 0.00291892 0.0 +2857 3.45 3.65 3.75 27.0106 27.9613 -27.0106 49.4083 -27.9613 -49.4083 0.0 +2858 3.45 3.65 11.25 14.9394 14.3629 -14.9394 5.91574 -14.3629 -5.91574 0.0 +2859 3.45 3.65 18.75 5.42704 4.99328 -5.42704 -0.785154 -4.99328 0.785155 0.0 +2860 3.45 3.65 26.25 1.05899 1.10476 -1.05899 -0.658621 -1.10476 0.658622 0.0 +2861 3.45 3.65 33.75 0.0281818 0.145917 -0.0281832 -0.129014 -0.145916 0.129014 0.0 +2862 3.45 3.65 41.25 -0.00445013 0.00847625 0.00444947 -0.00108348 -0.0084749 0.00108322 0.0 +2863 3.45 3.65 48.75 0.00425589 -0.0101956 -0.00425551 0.00738506 0.0101965 -0.00738428 0.0 +2864 3.45 3.65 56.25 -0.00818272 -0.00590468 0.00818308 0.00485965 0.00590354 -0.00486006 0.0 +2865 3.45 3.65 63.75 -0.00416452 -0.000816284 0.00416288 0.00103036 0.000813653 -0.00103209 0.0 +2866 3.45 3.65 71.25 0.00103127 -0.00146141 -0.00103277 0.000818187 0.00146199 -0.000819189 0.0 +2867 3.45 3.65 78.75 0.0016058 -0.00187691 -0.00160474 0.000733485 0.00187607 -0.000733211 0.0 +2868 3.45 3.65 86.25 0.00109362 -0.000919641 -0.00109306 -0.000877938 0.000920276 0.000877779 0.0 +2869 3.45 3.65 93.75 0.000615382 -0.000162543 -0.000614614 -0.00196718 0.000162038 0.00196727 0.0 +2870 3.45 3.65 101.25 0.000257077 -9.90887e-05 -0.000257803 -0.00198713 9.8806e-05 0.00198727 0.0 +2871 3.45 3.65 108.75 -0.000415666 -0.000551723 0.000416382 -0.00133258 0.000550085 0.00133277 0.0 +2872 3.45 3.65 116.25 -0.00171058 -0.00100344 0.00171033 -0.000283121 0.00100575 0.000281567 0.0 +2873 3.45 3.65 123.75 -0.00282345 -0.00136999 0.00282231 0.000681739 0.00136679 -0.000680174 0.0 +2874 3.45 3.65 131.25 -0.00293906 -0.00227991 0.00293814 0.00125143 0.00227664 -0.00125029 0.0 +2875 3.45 3.65 138.75 -0.00235433 -0.00392254 0.0023561 0.0016008 0.00392512 -0.00160107 0.0 +2876 3.45 3.65 146.25 -0.00181787 -0.00523799 0.00181858 0.00193355 0.00523773 -0.00193291 0.0 +2877 3.45 3.65 153.75 -0.00147655 -0.00473654 0.00147561 0.00211445 0.00473647 -0.00211477 0.0 +2878 3.45 3.65 161.25 -0.000967812 -0.00201348 0.000967111 0.00191586 0.00201087 -0.00191381 0.0 +2879 3.45 3.65 168.75 -0.000185572 0.00169462 0.000184459 0.00140918 -0.00169418 -0.00140983 0.0 +2880 3.45 3.65 176.25 0.000452234 0.00431542 -0.000452919 0.000978651 -0.00431348 -0.000979895 0.0 +2881 3.55 2.55 3.75 -229.406 -210.878 229.406 294.295 210.878 -294.295 0.0 +2882 3.55 2.55 11.25 -199.57 -142.531 199.57 214.774 142.531 -214.774 0.0 +2883 3.55 2.55 18.75 -155.766 -47.9091 155.766 136.693 47.9091 -136.693 0.0 +2884 3.55 2.55 26.25 -113.195 30.0688 113.195 89.2497 -30.0688 -89.2497 0.0 +2885 3.55 2.55 33.75 -77.4432 72.6073 77.4432 57.649 -72.6073 -57.649 0.0 +2886 3.55 2.55 41.25 -47.4313 83.435 47.4313 29.1262 -83.435 -29.1262 0.0 +2887 3.55 2.55 48.75 -21.4656 76.4023 21.4655 3.49717 -76.4023 -3.49717 0.0 +2888 3.55 2.55 56.25 0.0313289 64.405 -0.0313427 -14.8015 -64.405 14.8015 0.0 +2889 3.55 2.55 63.75 15.3842 54.1613 -15.3842 -23.4846 -54.1613 23.4846 0.0 +2890 3.55 2.55 71.25 23.5807 46.4646 -23.5807 -23.8098 -46.4646 23.8098 0.0 +2891 3.55 2.55 78.75 25.4225 39.3366 -25.4225 -19.2609 -39.3366 19.2609 0.0 +2892 3.55 2.55 86.25 23.3388 31.024 -23.3388 -13.5921 -31.0241 13.5921 0.0 +2893 3.55 2.55 93.75 20.1539 21.135 -20.1539 -9.24297 -21.135 9.24297 0.0 +2894 3.55 2.55 101.25 17.7701 10.268 -17.7701 -6.83623 -10.268 6.83623 0.0 +2895 3.55 2.55 108.75 16.6831 -0.675633 -16.6831 -5.75168 0.675638 5.75168 0.0 +2896 3.55 2.55 116.25 16.4196 -10.8522 -16.4196 -5.06569 10.8522 5.06568 0.0 +2897 3.55 2.55 123.75 16.2857 -19.5797 -16.2857 -4.17308 19.5797 4.17308 0.0 +2898 3.55 2.55 131.25 15.8485 -26.4045 -15.8485 -2.91647 26.4045 2.91647 0.0 +2899 3.55 2.55 138.75 15.02 -31.1759 -15.02 -1.42561 31.1759 1.4256 0.0 +2900 3.55 2.55 146.25 13.9278 -34.062 -13.9278 0.0838222 34.0619 -0.0838168 0.0 +2901 3.55 2.55 153.75 12.7687 -35.4729 -12.7687 1.42997 35.4729 -1.42997 0.0 +2902 3.55 2.55 161.25 11.7278 -35.927 -11.7278 2.49848 35.927 -2.49848 0.0 +2903 3.55 2.55 168.75 10.9505 -35.9169 -10.9505 3.23067 35.917 -3.23067 0.0 +2904 3.55 2.55 176.25 10.5363 -35.8139 -10.5363 3.60114 35.8139 -3.60114 0.0 +2905 3.55 2.65 3.75 -251.703 -244.274 251.703 410.77 244.274 -410.77 0.0 +2906 3.55 2.65 11.25 -212.889 -171.396 212.889 279.716 171.396 -279.716 0.0 +2907 3.55 2.65 18.75 -157.426 -73.7037 157.426 160.214 73.7037 -160.214 0.0 +2908 3.55 2.65 26.25 -106.127 3.62033 106.127 94.6298 -3.62033 -94.6298 0.0 +2909 3.55 2.65 33.75 -66.6414 43.9955 66.6414 57.7405 -43.9955 -57.7405 0.0 +2910 3.55 2.65 41.25 -37.1568 54.118 37.1568 29.0601 -54.118 -29.0601 0.0 +2911 3.55 2.65 48.75 -14.1506 48.9325 14.1506 5.36658 -48.9325 -5.36657 0.0 +2912 3.55 2.65 56.25 3.71459 40.5629 -3.71458 -10.365 -40.5629 10.365 0.0 +2913 3.55 2.65 63.75 16.0185 34.4708 -16.0185 -17.0997 -34.4708 17.0997 0.0 +2914 3.55 2.65 71.25 22.3492 30.686 -22.3492 -16.8785 -30.686 16.8785 0.0 +2915 3.55 2.65 78.75 23.4632 27.0893 -23.4632 -13.1658 -27.0893 13.1658 0.0 +2916 3.55 2.65 86.25 21.3128 22.1249 -21.3128 -9.07321 -22.1249 9.07321 0.0 +2917 3.55 2.65 93.75 18.1341 15.6344 -18.1341 -6.27069 -15.6344 6.2707 0.0 +2918 3.55 2.65 101.25 15.3987 8.31199 -15.3987 -4.90709 -8.31198 4.90709 0.0 +2919 3.55 2.65 108.75 13.4619 0.987899 -13.4619 -4.30622 -0.987895 4.30622 0.0 +2920 3.55 2.65 116.25 11.9812 -5.67249 -11.9811 -3.75874 5.67248 3.75874 0.0 +2921 3.55 2.65 123.75 10.533 -11.1925 -10.533 -2.9196 11.1925 2.9196 0.0 +2922 3.55 2.65 131.25 8.93728 -15.2892 -8.93728 -1.7942 15.2892 1.7942 0.0 +2923 3.55 2.65 138.75 7.2458 -17.9112 -7.24581 -0.551666 17.9112 0.551669 0.0 +2924 3.55 2.65 146.25 5.60299 -19.2413 -5.60297 0.632986 19.2413 -0.632993 0.0 +2925 3.55 2.65 153.75 4.14439 -19.6283 -4.1444 1.64399 19.6283 -1.64399 0.0 +2926 3.55 2.65 161.25 2.96848 -19.4785 -2.96847 2.42373 19.4785 -2.42373 0.0 +2927 3.55 2.65 168.75 2.14406 -19.1576 -2.14405 2.94939 19.1576 -2.94938 0.0 +2928 3.55 2.65 176.25 1.71892 -18.9295 -1.71891 3.21334 18.9295 -3.21334 0.0 +2929 3.55 2.75 3.75 -264.315 -251.884 264.315 554.153 251.884 -554.153 0.0 +2930 3.55 2.75 11.25 -218.018 -178.063 218.018 348.569 178.063 -348.569 0.0 +2931 3.55 2.75 18.75 -153.431 -82.237 153.431 177.523 82.237 -177.523 0.0 +2932 3.55 2.75 26.25 -95.9973 -9.58238 95.9973 92.8913 9.58238 -92.8913 0.0 +2933 3.55 2.75 33.75 -54.8909 26.1439 54.8909 52.4496 -26.1439 -52.4496 0.0 +2934 3.55 2.75 41.25 -27.4701 34.2513 27.4701 25.5556 -34.2513 -25.5556 0.0 +2935 3.55 2.75 48.75 -8.47775 30.1327 8.47774 5.12254 -30.1327 -5.12254 0.0 +2936 3.55 2.75 56.25 5.07875 24.538 -5.07874 -7.50333 -24.538 7.50333 0.0 +2937 3.55 2.75 63.75 13.9817 21.3671 -13.9817 -12.2962 -21.3671 12.2962 0.0 +2938 3.55 2.75 71.25 18.3904 19.9549 -18.3905 -11.6735 -19.9549 11.6735 0.0 +2939 3.55 2.75 78.75 18.9591 18.3138 -18.959 -8.76449 -18.3138 8.76449 0.0 +2940 3.55 2.75 86.25 17.0821 15.3211 -17.0821 -5.94741 -15.3211 5.94741 0.0 +2941 3.55 2.75 93.75 14.3506 11.1288 -14.3506 -4.23127 -11.1288 4.23127 0.0 +2942 3.55 2.75 101.25 11.7989 6.47419 -11.7989 -3.47648 -6.47418 3.47648 0.0 +2943 3.55 2.75 108.75 9.66457 2.01951 -9.66458 -3.0836 -2.0195 3.0836 0.0 +2944 3.55 2.75 116.25 7.74129 -1.82686 -7.7413 -2.58215 1.82685 2.58216 0.0 +2945 3.55 2.75 123.75 5.83466 -4.83284 -5.83465 -1.82939 4.83283 1.8294 0.0 +2946 3.55 2.75 131.25 3.93964 -6.88932 -3.93963 -0.91277 6.8893 0.912773 0.0 +2947 3.55 2.75 138.75 2.16628 -8.02362 -2.16626 0.0181776 8.02364 -0.0181816 0.0 +2948 3.55 2.75 146.25 0.619367 -8.40184 -0.619378 0.852629 8.40183 -0.852624 0.0 +2949 3.55 2.75 153.75 -0.648178 -8.27967 0.648181 1.53734 8.27967 -1.53733 0.0 +2950 3.55 2.75 161.25 -1.61826 -7.92733 1.61826 2.0554 7.92733 -2.0554 0.0 +2951 3.55 2.75 168.75 -2.27916 -7.56871 2.27916 2.4029 7.56872 -2.4029 0.0 +2952 3.55 2.75 176.25 -2.61565 -7.3533 2.61565 2.5776 7.35327 -2.57759 0.0 +2953 3.55 2.85 3.75 -261.527 -235.81 261.527 724.836 235.81 -724.836 0.0 +2954 3.55 2.85 11.25 -211.244 -166.597 211.244 416.164 166.597 -416.164 0.0 +2955 3.55 2.85 18.75 -142.48 -78.6912 142.48 186.852 78.6912 -186.852 0.0 +2956 3.55 2.85 26.25 -83.1221 -14.2229 83.1221 84.8442 14.223 -84.8442 0.0 +2957 3.55 2.85 33.75 -43.0885 15.5567 43.0885 43.3483 -15.5567 -43.3483 0.0 +2958 3.55 2.85 41.25 -19.0807 21.2967 19.0807 20.0983 -21.2967 -20.0983 0.0 +2959 3.55 2.85 48.75 -4.56564 17.9239 4.56566 3.89029 -17.9239 -3.89029 0.0 +2960 3.55 2.85 56.25 4.68974 14.4266 -4.68973 -5.45881 -14.4266 5.45881 0.0 +2961 3.55 2.85 63.75 10.3993 13.1365 -10.3993 -8.55525 -13.1365 8.55525 0.0 +2962 3.55 2.85 71.25 13.149 12.9016 -13.149 -7.76157 -12.9016 7.76157 0.0 +2963 3.55 2.85 78.75 13.4264 12.095 -13.4264 -5.62748 -12.095 5.62748 0.0 +2964 3.55 2.85 86.25 12.0608 10.1297 -12.0608 -3.80584 -10.1297 3.80584 0.0 +2965 3.55 2.85 93.75 10.0367 7.43249 -10.0367 -2.80863 -7.4325 2.80863 0.0 +2966 3.55 2.85 101.25 8.01353 4.69251 -8.01354 -2.3777 -4.69252 2.3777 0.0 +2967 3.55 2.85 108.75 6.15338 2.33759 -6.15338 -2.06536 -2.33757 2.06536 0.0 +2968 3.55 2.85 116.25 4.37451 0.505156 -4.37452 -1.6121 -0.505158 1.61211 0.0 +2969 3.55 2.85 123.75 2.64685 -0.790656 -2.64685 -1.0014 0.790603 1.00141 0.0 +2970 3.55 2.85 131.25 1.0548 -1.57001 -1.05481 -0.336579 1.57001 0.336585 0.0 +2971 3.55 2.85 138.75 -0.301249 -1.89549 0.301247 0.282316 1.8955 -0.282321 0.0 +2972 3.55 2.85 146.25 -1.3849 -1.88523 1.38489 0.806188 1.88523 -0.806188 0.0 +2973 3.55 2.85 153.75 -2.21895 -1.68823 2.21895 1.22569 1.68826 -1.2257 0.0 +2974 3.55 2.85 161.25 -2.83872 -1.44066 2.83873 1.54425 1.44064 -1.54424 0.0 +2975 3.55 2.85 168.75 -3.25933 -1.23657 3.25933 1.76182 1.23656 -1.76182 0.0 +2976 3.55 2.85 176.25 -3.47478 -1.12538 3.47479 1.87313 1.12538 -1.87313 0.0 +2977 3.55 2.95 3.75 -238.248 -195.778 238.248 919.354 195.778 -919.354 0.0 +2978 3.55 2.95 11.25 -189.674 -139.46 189.674 474.265 139.46 -474.265 0.0 +2979 3.55 2.95 18.75 -123.906 -67.0584 123.906 186.836 67.0584 -186.836 0.0 +2980 3.55 2.95 26.25 -68.0315 -14.1389 68.0315 72.1684 14.1389 -72.1684 0.0 +2981 3.55 2.95 33.75 -31.9787 9.22621 31.9787 32.4164 -9.22622 -32.4164 0.0 +2982 3.55 2.95 41.25 -12.3582 12.9007 12.3583 14.1095 -12.9007 -14.1095 0.0 +2983 3.55 2.95 48.75 -2.18494 10.2138 2.18496 2.49295 -10.2139 -2.49296 0.0 +2984 3.55 2.95 56.25 3.3582 8.24208 -3.35821 -3.79474 -8.24206 3.79474 0.0 +2985 3.55 2.95 63.75 6.49294 8.02143 -6.49294 -5.58908 -8.02143 5.58908 0.0 +2986 3.55 2.95 71.25 8.02049 8.19907 -8.0205 -4.84949 -8.19905 4.84949 0.0 +2987 3.55 2.95 78.75 8.22344 7.62696 -8.22344 -3.42621 -7.62696 3.42621 0.0 +2988 3.55 2.95 86.25 7.44006 6.19885 -7.44002 -2.34519 -6.19886 2.34519 0.0 +2989 3.55 2.95 93.75 6.16909 4.49074 -6.16911 -1.80008 -4.49073 1.80008 0.0 +2990 3.55 2.95 101.25 4.7983 3.05613 -4.79831 -1.53727 -3.05611 1.53727 0.0 +2991 3.55 2.95 108.75 3.45573 2.08096 -3.45575 -1.27583 -2.08101 1.27584 0.0 +2992 3.55 2.95 116.25 2.15328 1.48623 -2.15328 -0.907415 -1.48624 0.907424 0.0 +2993 3.55 2.95 123.75 0.949834 1.14548 -0.949837 -0.471692 -1.14549 0.471698 0.0 +2994 3.55 2.95 131.25 -0.0550126 0.978085 0.0550168 -0.0490852 -0.978089 0.0490994 0.0 +2995 3.55 2.95 138.75 -0.810377 0.930404 0.810378 0.312048 -0.930407 -0.312044 0.0 +2996 3.55 2.95 146.25 -1.34711 0.946474 1.34711 0.605449 -0.946508 -0.605443 0.0 +2997 3.55 2.95 153.75 -1.73568 0.972292 1.73566 0.843093 -0.972294 -0.843115 0.0 +2998 3.55 2.95 161.25 -2.0293 0.976791 2.0293 1.03229 -0.976772 -1.0323 0.0 +2999 3.55 2.95 168.75 -2.2408 0.960264 2.24081 1.16853 -0.960251 -1.16853 0.0 +3000 3.55 2.95 176.25 -2.35501 0.942937 2.355 1.24087 -0.942925 -1.24088 0.0 +3001 3.55 3.05 3.75 -191.297 -130.082 191.297 1128.5 130.082 -1128.5 0.0 +3002 3.55 3.05 11.25 -152.226 -97.7637 152.226 511.643 97.7637 -511.643 0.0 +3003 3.55 3.05 18.75 -98.1201 -49.6499 98.1201 176.712 49.6499 -176.712 0.0 +3004 3.55 3.05 26.25 -51.5683 -11.65 51.5683 57.077 11.65 -57.077 0.0 +3005 3.55 3.05 33.75 -22.1446 5.20584 22.1446 21.6579 -5.20585 -21.6579 0.0 +3006 3.55 3.05 41.25 -7.38019 7.37579 7.38014 8.71709 -7.37577 -8.71708 0.0 +3007 3.55 3.05 48.75 -0.926333 5.37849 0.926342 1.38286 -5.3785 -1.38286 0.0 +3008 3.55 3.05 56.25 1.85514 4.42058 -1.85514 -2.37141 -4.42058 2.3714 0.0 +3009 3.55 3.05 63.75 3.22617 4.68783 -3.22619 -3.29462 -4.68786 3.29461 0.0 +3010 3.55 3.05 71.25 3.99011 4.90415 -3.99008 -2.75614 -4.9041 2.75615 0.0 +3011 3.55 3.05 78.75 4.23211 4.38385 -4.2321 -1.92599 -4.38384 1.92599 0.0 +3012 3.55 3.05 86.25 3.94062 3.32631 -3.9406 -1.36028 -3.3263 1.36028 0.0 +3013 3.55 3.05 93.75 3.29323 2.3031 -3.29324 -1.08948 -2.30313 1.08948 0.0 +3014 3.55 3.05 101.25 2.51472 1.68908 -2.51471 -0.92722 -1.68906 0.92722 0.0 +3015 3.55 3.05 108.75 1.72258 1.48366 -1.72257 -0.729229 -1.48363 0.72922 0.0 +3016 3.55 3.05 116.25 0.978063 1.49003 -0.978058 -0.472368 -1.49006 0.47237 0.0 +3017 3.55 3.05 123.75 0.361941 1.5347 -0.361928 -0.204692 -1.53463 0.204681 0.0 +3018 3.55 3.05 131.25 -0.0580488 1.53872 0.0580497 0.0271852 -1.53873 -0.02718 0.0 +3019 3.55 3.05 138.75 -0.288182 1.48156 0.28818 0.211303 -1.48158 -0.211288 0.0 +3020 3.55 3.05 146.25 -0.402687 1.35988 0.402687 0.361419 -1.35985 -0.361436 0.0 +3021 3.55 3.05 153.75 -0.484044 1.18137 0.484038 0.493182 -1.18138 -0.493177 0.0 +3022 3.55 3.05 161.25 -0.573201 0.974726 0.573209 0.609288 -0.974728 -0.60928 0.0 +3023 3.55 3.05 168.75 -0.662445 0.789454 0.662456 0.699577 -0.789456 -0.699573 0.0 +3024 3.55 3.05 176.25 -0.7198 0.679375 0.719786 0.749601 -0.679392 -0.749593 0.0 +3025 3.55 3.15 3.75 -120.535 -38.5135 120.535 1334.4 38.5135 -1334.4 0.0 +3026 3.55 3.15 11.25 -100.361 -42.9397 100.361 515.461 42.9397 -515.461 0.0 +3027 3.55 3.15 18.75 -66.8257 -27.6715 66.8257 156.437 27.6715 -156.437 0.0 +3028 3.55 3.15 26.25 -34.8806 -7.69081 34.8806 41.7654 7.69081 -41.7654 0.0 +3029 3.55 3.15 33.75 -13.9952 2.60989 13.9952 12.6685 -2.60989 -12.6685 0.0 +3030 3.55 3.15 41.25 -4.0045 3.76721 4.00452 4.60296 -3.76722 -4.60296 0.0 +3031 3.55 3.15 48.75 -0.362908 2.40871 0.362911 0.684517 -2.40873 -0.684496 0.0 +3032 3.55 3.15 56.25 0.698355 2.02222 -0.698341 -1.23238 -2.0222 1.23238 0.0 +3033 3.55 3.15 63.75 1.08795 2.40699 -1.08797 -1.65461 -2.40696 1.65462 0.0 +3034 3.55 3.15 71.25 1.45251 2.55615 -1.45253 -1.35584 -2.55613 1.35584 0.0 +3035 3.55 3.15 78.75 1.73638 2.12607 -1.73637 -0.957408 -2.12608 0.957409 0.0 +3036 3.55 3.15 86.25 1.74868 1.41086 -1.74869 -0.717153 -1.41085 0.717153 0.0 +3037 3.55 3.15 93.75 1.5066 0.86199 -1.5066 -0.608615 -0.862043 0.608616 0.0 +3038 3.55 3.15 101.25 1.15427 0.692349 -1.15426 -0.521959 -0.692347 0.521961 0.0 +3039 3.55 3.15 108.75 0.799794 0.807097 -0.799796 -0.399775 -0.80711 0.399772 0.0 +3040 3.55 3.15 116.25 0.510123 0.993297 -0.510111 -0.252463 -0.993286 0.252463 0.0 +3041 3.55 3.15 123.75 0.344561 1.10258 -0.344571 -0.114896 -1.10259 0.114902 0.0 +3042 3.55 3.15 131.25 0.32494 1.09044 -0.324933 -0.00704299 -1.09044 0.00704928 0.0 +3043 3.55 3.15 138.75 0.404925 0.966593 -0.404949 0.0762265 -0.966647 -0.0762275 0.0 +3044 3.55 3.15 146.25 0.499444 0.753676 -0.499415 0.151485 -0.753669 -0.151477 0.0 +3045 3.55 3.15 153.75 0.542832 0.481048 -0.542816 0.22901 -0.481047 -0.229008 0.0 +3046 3.55 3.15 161.25 0.522198 0.193975 -0.522177 0.305586 -0.193965 -0.305594 0.0 +3047 3.55 3.15 168.75 0.468573 -0.0480481 -0.468564 0.368598 0.048046 -0.368601 0.0 +3048 3.55 3.15 176.25 0.426757 -0.187013 -0.426752 0.404298 0.186996 -0.404293 0.0 +3049 3.55 3.25 3.75 -29.6653 73.925 29.6653 1503.64 -73.925 -1503.64 0.0 +3050 3.55 3.25 11.25 -38.343 21.1792 38.343 474.484 -21.1792 -474.484 0.0 +3051 3.55 3.25 18.75 -32.9234 -2.3694 32.9234 126.727 2.3694 -126.727 0.0 +3052 3.55 3.25 26.25 -19.3004 -2.48733 19.3004 27.8286 2.48732 -27.8286 0.0 +3053 3.55 3.25 33.75 -7.74679 1.20452 7.74681 6.29538 -1.20452 -6.29539 0.0 +3054 3.55 3.25 41.25 -1.94619 1.60378 1.94618 1.96617 -1.60377 -1.96616 0.0 +3055 3.55 3.25 48.75 -0.157335 0.755813 0.157348 0.31596 -0.755837 -0.315945 0.0 +3056 3.55 3.25 56.25 0.0714287 0.611962 -0.0714357 -0.460837 -0.611969 0.460849 0.0 +3057 3.55 3.25 63.75 0.0702285 0.923583 -0.0701829 -0.637809 -0.923614 0.637808 0.0 +3058 3.55 3.25 71.25 0.254878 1.02447 -0.25488 -0.526913 -1.02446 0.526913 0.0 +3059 3.55 3.25 78.75 0.514287 0.758419 -0.514308 -0.387335 -0.758396 0.387332 0.0 +3060 3.55 3.25 86.25 0.632201 0.354653 -0.632241 -0.323832 -0.354649 0.323832 0.0 +3061 3.55 3.25 93.75 0.582318 0.103028 -0.582347 -0.305332 -0.103026 0.305331 0.0 +3062 3.55 3.25 101.25 0.46996 0.111698 -0.46996 -0.276841 -0.111679 0.276842 0.0 +3063 3.55 3.25 108.75 0.380585 0.279066 -0.380591 -0.223034 -0.279092 0.223042 0.0 +3064 3.55 3.25 116.25 0.358122 0.44336 -0.358142 -0.159424 -0.443412 0.159434 0.0 +3065 3.55 3.25 123.75 0.427025 0.512673 -0.427042 -0.104868 -0.51267 0.104858 0.0 +3066 3.55 3.25 131.25 0.574576 0.475402 -0.574594 -0.0645124 -0.475427 0.0645121 0.0 +3067 3.55 3.25 138.75 0.741562 0.351546 -0.741556 -0.0294911 -0.351565 0.0294968 0.0 +3068 3.55 3.25 146.25 0.857969 0.161727 -0.85796 0.0114794 -0.16175 -0.0114787 0.0 +3069 3.55 3.25 153.75 0.888764 -0.0710245 -0.888769 0.0613246 0.071072 -0.0613482 0.0 +3070 3.55 3.25 161.25 0.848268 -0.311204 -0.848278 0.113131 0.311192 -0.113144 0.0 +3071 3.55 3.25 168.75 0.781206 -0.511438 -0.781203 0.155702 0.511431 -0.155695 0.0 +3072 3.55 3.25 176.25 0.733873 -0.625736 -0.733895 0.1795 0.625763 -0.179513 0.0 +3073 3.55 3.35 3.75 70.5641 186.771 -70.5641 1508.57 -186.771 -1508.57 0.0 +3074 3.55 3.35 11.25 26.1135 83.8672 -26.1135 369.137 -83.8672 -369.137 0.0 +3075 3.55 3.35 18.75 -0.0874673 23.0482 0.0874728 85.6093 -23.0482 -85.6093 0.0 +3076 3.55 3.35 26.25 -5.90552 3.52135 5.90552 15.2641 -3.52136 -15.2641 0.0 +3077 3.55 3.35 33.75 -3.28275 0.861657 3.28277 2.42219 -0.861647 -2.42219 0.0 +3078 3.55 3.35 41.25 -0.811789 0.540902 0.811771 0.587392 -0.540899 -0.587387 0.0 +3079 3.55 3.35 48.75 -0.092098 0.0540773 0.0921139 0.12834 -0.0540653 -0.128329 0.0 +3080 3.55 3.35 56.25 -0.113419 -0.0251278 0.113414 -0.065704 0.0251121 0.0657004 0.0 +3081 3.55 3.35 63.75 -0.169707 0.151465 0.169684 -0.136214 -0.151455 0.136224 0.0 +3082 3.55 3.35 71.25 -0.0770462 0.234517 0.0770254 -0.122786 -0.234512 0.122797 0.0 +3083 3.55 3.35 78.75 0.080157 0.14264 -0.0801127 -0.0976888 -0.142618 0.0976915 0.0 +3084 3.55 3.35 86.25 0.16526 -0.0245321 -0.16523 -0.105724 0.0245585 0.105724 0.0 +3085 3.55 3.35 93.75 0.16494 -0.121904 -0.164953 -0.124366 0.121903 0.124366 0.0 +3086 3.55 3.35 101.25 0.150547 -0.0889324 -0.150553 -0.128054 0.0889257 0.128048 0.0 +3087 3.55 3.35 108.75 0.170286 0.0175738 -0.170291 -0.117975 -0.0175791 0.117976 0.0 +3088 3.55 3.35 116.25 0.23787 0.110881 -0.237884 -0.105416 -0.110839 0.105397 0.0 +3089 3.55 3.35 123.75 0.352555 0.149885 -0.352566 -0.0967577 -0.149898 0.0967502 0.0 +3090 3.55 3.35 131.25 0.489812 0.135495 -0.489818 -0.0893887 -0.135477 0.0893863 0.0 +3091 3.55 3.35 138.75 0.60086 0.077142 -0.600855 -0.0756476 -0.0771297 0.0756365 0.0 +3092 3.55 3.35 146.25 0.643546 -0.0196771 -0.643564 -0.0510493 0.0196634 0.0510486 0.0 +3093 3.55 3.35 153.75 0.611551 -0.145928 -0.611561 -0.0188268 0.145921 0.0188254 0.0 +3094 3.55 3.35 161.25 0.533916 -0.281245 -0.533921 0.0128836 0.281282 -0.0128976 0.0 +3095 3.55 3.35 168.75 0.453006 -0.396367 -0.453027 0.0367463 0.396347 -0.036746 0.0 +3096 3.55 3.35 176.25 0.403626 -0.462625 -0.403626 0.0491182 0.462593 -0.0490967 0.0 +3097 3.55 3.45 3.75 121.762 207.785 -121.762 962.688 -207.785 -962.688 0.0 +3098 3.55 3.45 11.25 60.8866 100.045 -60.8866 171.897 -100.045 -171.897 0.0 +3099 3.55 3.45 18.75 19.2588 32.9384 -19.2588 31.2407 -32.9384 -31.2407 0.0 +3100 3.55 3.45 26.25 2.44295 6.83148 -2.44294 3.77225 -6.83148 -3.77225 0.0 +3101 3.55 3.45 33.75 -0.567079 0.958398 0.567088 0.416847 -0.958393 -0.416854 0.0 +3102 3.55 3.45 41.25 -0.222537 0.179899 0.222522 0.084085 -0.179913 -0.0840813 0.0 +3103 3.55 3.45 48.75 -0.0448672 -0.0437923 0.0448399 0.028244 0.0437888 -0.0282332 0.0 +3104 3.55 3.45 56.25 -0.0627155 -0.090292 0.0626997 0.0294423 0.0902953 -0.0294398 0.0 +3105 3.55 3.45 63.75 -0.0651564 -0.0351753 0.0651434 0.00414308 0.035192 -0.00412588 0.0 +3106 3.55 3.45 71.25 -0.042218 0.0132608 0.0422006 -0.00188957 -0.0132483 0.00189618 0.0 +3107 3.55 3.45 78.75 -0.0116982 0.0190232 0.011707 1.57271e-05 -0.0190144 -1.64085e-05 0.0 +3108 3.55 3.45 86.25 0.00013451 -0.0138769 -0.000144209 -0.0123824 0.0138849 0.0123821 0.0 +3109 3.55 3.45 93.75 -0.00393746 -0.0447471 0.00392985 -0.0246058 0.0447166 0.0246083 0.0 +3110 3.55 3.45 101.25 0.00141228 -0.0409447 -0.0013985 -0.0283161 0.0409468 0.0283156 0.0 +3111 3.55 3.45 108.75 0.0263281 -0.010178 -0.0263265 -0.0311072 0.0101511 0.0311133 0.0 +3112 3.55 3.45 116.25 0.0681867 0.0249438 -0.0681732 -0.0385014 -0.0249297 0.0385108 0.0 +3113 3.55 3.45 123.75 0.121836 0.0519122 -0.121824 -0.0480196 -0.0519073 0.048018 0.0 +3114 3.55 3.45 131.25 0.172268 0.0658221 -0.17226 -0.0530535 -0.0658407 0.0530668 0.0 +3115 3.55 3.45 138.75 0.195564 0.0618726 -0.19556 -0.0485273 -0.0619059 0.0485432 0.0 +3116 3.55 3.45 146.25 0.177362 0.0378149 -0.17737 -0.0351206 -0.0378521 0.0351336 0.0 +3117 3.55 3.45 153.75 0.125251 -0.00187406 -0.125266 -0.0186947 0.00187352 0.018683 0.0 +3118 3.55 3.45 161.25 0.0620088 -0.0466966 -0.0619998 -0.0055378 0.0466948 0.00554231 0.0 +3119 3.55 3.45 168.75 0.00986362 -0.0846755 -0.00985828 0.00176039 0.0846777 -0.00175711 0.0 +3120 3.55 3.45 176.25 -0.0183927 -0.10623 0.0183719 0.00441031 0.106201 -0.00440336 0.0 +3121 3.55 3.55 3.75 81.0059 113.34 -81.0059 260.352 -113.34 -260.352 0.0 +3122 3.55 3.55 11.25 42.1524 56.4121 -42.1524 26.3617 -56.4121 -26.3617 0.0 +3123 3.55 3.55 18.75 14.7132 19.7973 -14.7132 -0.755035 -19.7973 0.755033 0.0 +3124 3.55 3.55 26.25 2.79612 4.5306 -2.79613 -1.38915 -4.53059 1.38915 0.0 +3125 3.55 3.55 33.75 0.10053 0.64794 -0.100533 -0.160016 -0.647941 0.160018 0.0 +3126 3.55 3.55 41.25 -0.0178303 0.07505 0.0178293 0.0195223 -0.0750523 -0.0195244 0.0 +3127 3.55 3.55 48.75 -0.00517875 -0.00351167 0.00518041 0.00760166 0.00350383 -0.00760536 0.0 +3128 3.55 3.55 56.25 -0.0146237 -0.0107977 0.0146179 0.0109189 0.0107984 -0.0109269 0.0 +3129 3.55 3.55 63.75 -3.87507e-05 -0.00362228 4.15324e-05 -0.000860953 0.0036153 0.000862609 0.0 +3130 3.55 3.55 71.25 0.00025554 0.00310581 -0.000258051 -0.00193062 -0.00311301 0.00192984 0.0 +3131 3.55 3.55 78.75 -0.00939829 0.0115235 0.0094016 0.000961058 -0.0115276 -0.000962838 0.0 +3132 3.55 3.55 86.25 -0.0165596 0.0133942 0.0165552 -0.000618444 -0.0133937 0.000618414 0.0 +3133 3.55 3.55 93.75 -0.0192198 0.0081303 0.0192237 0.000800086 -0.00813014 -0.000800389 0.0 +3134 3.55 3.55 101.25 -0.0173135 0.00397392 0.017316 0.00498683 -0.0039722 -0.00498686 0.0 +3135 3.55 3.55 108.75 -0.0127763 0.00613703 0.0127729 0.00547732 -0.00614031 -0.00547708 0.0 +3136 3.55 3.55 116.25 -0.00660985 0.0146966 0.00660871 0.000809944 -0.0146938 -0.000810497 0.0 +3137 3.55 3.55 123.75 0.00134833 0.025362 -0.00135008 -0.00514917 -0.0253577 0.0051477 0.0 +3138 3.55 3.55 131.25 0.00729171 0.0312649 -0.00729682 -0.00779015 -0.0312805 0.00779548 0.0 +3139 3.55 3.55 138.75 0.00442273 0.0279187 -0.00442424 -0.00517592 -0.0279147 0.00517078 0.0 +3140 3.55 3.55 146.25 -0.0095565 0.0168767 0.00955964 0.000965394 -0.0168727 -0.000968108 0.0 +3141 3.55 3.55 153.75 -0.0293138 0.00381127 0.0293123 0.00695552 -0.00382228 -0.00695117 0.0 +3142 3.55 3.55 161.25 -0.0467198 -0.00619086 0.0467172 0.0101031 0.00618452 -0.0101001 0.0 +3143 3.55 3.55 168.75 -0.0572524 -0.0115126 0.0572543 0.0103575 0.0115196 -0.0103592 0.0 +3144 3.55 3.55 176.25 -0.0614583 -0.0133864 0.0614549 0.00960442 0.0133863 -0.00960501 0.0 +3145 3.55 3.65 3.75 12.0786 14.33 -12.0786 4.38613 -14.33 -4.38613 0.0 +3146 3.55 3.65 11.25 6.33912 7.33576 -6.33912 -3.18423 -7.33576 3.18423 0.0 +3147 3.55 3.65 18.75 2.17784 2.6298 -2.17784 -1.96003 -2.6298 1.96003 0.0 +3148 3.55 3.65 26.25 0.39006 0.617253 -0.390059 -0.575786 -0.617253 0.575786 0.0 +3149 3.55 3.65 33.75 0.012681 0.0862211 -0.0126807 -0.0681723 -0.0862212 0.0681722 0.0 +3150 3.55 3.65 41.25 0.00502234 0.00223156 -0.00502212 0.00459513 -0.00223169 -0.00459442 0.0 +3151 3.55 3.65 48.75 0.00119944 -0.00628422 -0.00119894 0.00406756 0.00628446 -0.004068 0.0 +3152 3.55 3.65 56.25 -0.00386742 -0.003943 0.0038666 0.00178896 0.00394351 -0.00178918 0.0 +3153 3.55 3.65 63.75 -8.12468e-05 -0.00348925 8.0267e-05 -0.000674629 0.00348964 0.000674362 0.0 +3154 3.55 3.65 71.25 0.00192557 -0.00505585 -0.00192533 -0.00075298 0.00505521 0.00075297 0.0 +3155 3.55 3.65 78.75 0.00130323 -0.00454114 -0.0013032 -0.000636843 0.00454084 0.000636893 0.0 +3156 3.55 3.65 86.25 0.000803867 -0.00245655 -0.00080399 -0.00102105 0.0024577 0.00102106 0.0 +3157 3.55 3.65 93.75 0.0005973 -0.00111275 -0.000596389 -0.00057336 0.00111433 0.000573242 0.0 +3158 3.55 3.65 101.25 8.21929e-06 -0.00103481 -8.12152e-06 0.000450279 0.00103466 -0.00045023 0.0 +3159 3.55 3.65 108.75 -0.00119309 -0.00126494 0.00119399 0.0010993 0.00126523 -0.00109935 0.0 +3160 3.55 3.65 116.25 -0.00250233 -0.00111306 0.0025023 0.00122707 0.00111394 -0.00122737 0.0 +3161 3.55 3.65 123.75 -0.00325961 -0.00112678 0.00325939 0.00125572 0.00112681 -0.00125599 0.0 +3162 3.55 3.65 131.25 -0.0035151 -0.00233904 0.00351542 0.00158179 0.00233879 -0.00158147 0.0 +3163 3.55 3.65 138.75 -0.00380524 -0.00487295 0.00380513 0.00228977 0.0048732 -0.00229011 0.0 +3164 3.55 3.65 146.25 -0.00421555 -0.00763611 0.00421483 0.00312216 0.00763468 -0.00312155 0.0 +3165 3.55 3.65 153.75 -0.0041875 -0.00929866 0.0041879 0.00369562 0.00929919 -0.00369561 0.0 +3166 3.55 3.65 161.25 -0.00326306 -0.00936525 0.00326349 0.00381045 0.00936578 -0.00381069 0.0 +3167 3.55 3.65 168.75 -0.00175148 -0.00841033 0.00175132 0.00358917 0.00841037 -0.00358917 0.0 +3168 3.55 3.65 176.25 -0.000592392 -0.007527 0.000592354 0.00335056 0.00752733 -0.00335069 0.0 +3169 3.65 2.55 3.75 -40.009 -15.4008 40.009 40.0274 15.4008 -40.0274 0.0 +3170 3.65 2.55 11.25 -35.9275 -8.01432 35.9275 33.2501 8.01432 -33.2501 0.0 +3171 3.65 2.55 18.75 -29.1111 2.18604 29.1111 25.2314 -2.18604 -25.2314 0.0 +3172 3.65 2.55 26.25 -21.3547 10.3626 21.3547 18.2796 -10.3626 -18.2796 0.0 +3173 3.65 2.55 33.75 -13.9719 14.348 13.9719 11.7967 -14.348 -11.7967 0.0 +3174 3.65 2.55 41.25 -7.5442 14.6453 7.54421 5.59102 -14.6453 -5.59102 0.0 +3175 3.65 2.55 48.75 -2.24061 13.0038 2.24061 0.431082 -13.0038 -0.431082 0.0 +3176 3.65 2.55 56.25 1.8288 11.0249 -1.8288 -2.89428 -11.0249 2.89428 0.0 +3177 3.65 2.55 63.75 4.53289 9.46602 -4.53289 -4.23204 -9.46602 4.23204 0.0 +3178 3.65 2.55 71.25 5.85495 8.2892 -5.85495 -4.06592 -8.2892 4.06592 0.0 +3179 3.65 2.55 78.75 6.02504 7.12145 -6.02504 -3.16889 -7.12145 3.16889 0.0 +3180 3.65 2.55 86.25 5.48507 5.68167 -5.48507 -2.21374 -5.68167 2.21374 0.0 +3181 3.65 2.55 93.75 4.69928 3.93064 -4.69928 -1.54457 -3.93064 1.54457 0.0 +3182 3.65 2.55 101.25 3.96919 2.00212 -3.96919 -1.18342 -2.00212 1.18342 0.0 +3183 3.65 2.55 108.75 3.38632 0.0868782 -3.38632 -0.988945 -0.0868777 0.988945 0.0 +3184 3.65 2.55 116.25 2.91224 -1.63935 -2.91224 -0.817586 1.63935 0.817586 0.0 +3185 3.65 2.55 123.75 2.48437 -3.04769 -2.48437 -0.599486 3.04769 0.599486 0.0 +3186 3.65 2.55 131.25 2.07217 -4.07177 -2.07217 -0.334193 4.07177 0.334193 0.0 +3187 3.65 2.55 138.75 1.67928 -4.7127 -1.67928 -0.0541061 4.7127 0.0541055 0.0 +3188 3.65 2.55 146.25 1.324 -5.02905 -1.324 0.206511 5.02905 -0.206511 0.0 +3189 3.65 2.55 153.75 1.02384 -5.11434 -1.02384 0.42501 5.11435 -0.425011 0.0 +3190 3.65 2.55 161.25 0.790618 -5.0708 -0.79062 0.59084 5.0708 -0.59084 0.0 +3191 3.65 2.55 168.75 0.631514 -4.98804 -0.631514 0.701038 4.98804 -0.701038 0.0 +3192 3.65 2.55 176.25 0.550863 -4.9302 -0.550863 0.755804 4.93019 -0.755804 0.0 +3193 3.65 2.65 3.75 -40.3415 -20.4462 40.3414 48.2003 20.4462 -48.2003 0.0 +3194 3.65 2.65 11.25 -35.6139 -12.537 35.6139 37.6321 12.537 -37.6321 0.0 +3195 3.65 2.65 18.75 -27.8935 -1.94676 27.8935 26.3964 1.94676 -26.3964 0.0 +3196 3.65 2.65 26.25 -19.4761 6.1859 19.4761 18.0571 -6.1859 -18.0571 0.0 +3197 3.65 2.65 33.75 -11.9713 9.93876 11.9713 11.3141 -9.93876 -11.3141 0.0 +3198 3.65 2.65 41.25 -5.94346 10.1979 5.94346 5.35283 -10.1979 -5.35283 0.0 +3199 3.65 2.65 48.75 -1.33924 8.87517 1.33925 0.645199 -8.87517 -0.645199 0.0 +3200 3.65 2.65 56.25 1.99711 7.47429 -1.99711 -2.21792 -7.47429 2.21792 0.0 +3201 3.65 2.65 63.75 4.13172 6.56384 -4.13172 -3.25512 -6.56384 3.25512 0.0 +3202 3.65 2.65 71.25 5.12808 5.97847 -5.12807 -3.03446 -5.97846 3.03446 0.0 +3203 3.65 2.65 78.75 5.18813 5.32387 -5.18814 -2.29047 -5.32387 2.29047 0.0 +3204 3.65 2.65 86.25 4.66497 4.36756 -4.66497 -1.57788 -4.36756 1.57788 0.0 +3205 3.65 2.65 93.75 3.92751 3.12819 -3.92751 -1.12411 -3.12819 1.12411 0.0 +3206 3.65 2.65 101.25 3.21269 1.76422 -3.21269 -0.893827 -1.76422 0.893826 0.0 +3207 3.65 2.65 108.75 2.59178 0.449106 -2.59178 -0.752929 -0.449104 0.752929 0.0 +3208 3.65 2.65 116.25 2.0428 -0.685103 -2.0428 -0.59797 0.685104 0.597969 0.0 +3209 3.65 2.65 123.75 1.53526 -1.55782 -1.53526 -0.396906 1.55781 0.396906 0.0 +3210 3.65 2.65 131.25 1.06531 -2.13944 -1.0653 -0.167518 2.13944 0.167517 0.0 +3211 3.65 2.65 138.75 0.647302 -2.44867 -0.6473 0.0582564 2.44867 -0.0582566 0.0 +3212 3.65 2.65 146.25 0.295526 -2.54219 -0.295526 0.256206 2.54219 -0.256206 0.0 +3213 3.65 2.65 153.75 0.015987 -2.49637 -0.0159868 0.414877 2.49637 -0.414877 0.0 +3214 3.65 2.65 161.25 -0.191615 -2.38798 0.191615 0.531758 2.38798 -0.531758 0.0 +3215 3.65 2.65 168.75 -0.329232 -2.2801 0.329232 0.608128 2.2801 -0.608129 0.0 +3216 3.65 2.65 176.25 -0.397947 -2.21557 0.397946 0.645792 2.21557 -0.645792 0.0 +3217 3.65 2.75 3.75 -39.2092 -22.6483 39.2092 57.4865 22.6483 -57.4865 0.0 +3218 3.65 2.75 11.25 -34.0902 -14.5832 34.0902 41.5462 14.5832 -41.5462 0.0 +3219 3.65 2.75 18.75 -25.8464 -4.11523 25.8464 26.3647 4.11523 -26.3647 0.0 +3220 3.65 2.75 26.25 -17.1522 3.55165 17.1522 16.7014 -3.55165 -16.7014 0.0 +3221 3.65 2.75 33.75 -9.84656 6.82027 9.84656 10.0278 -6.82027 -10.0278 0.0 +3222 3.65 2.75 41.25 -4.45564 6.92657 4.45564 4.64181 -6.92657 -4.64181 0.0 +3223 3.65 2.75 48.75 -0.70807 5.85889 0.708069 0.607165 -5.85889 -0.607165 0.0 +3224 3.65 2.75 56.25 1.80566 4.93589 -1.80566 -1.70515 -4.93589 1.70515 0.0 +3225 3.65 2.75 63.75 3.33924 4.49868 -3.33924 -2.44435 -4.49868 2.44435 0.0 +3226 3.65 2.75 71.25 4.02671 4.27839 -4.02671 -2.19705 -4.27839 2.19705 0.0 +3227 3.65 2.75 78.75 4.02726 3.91248 -4.02727 -1.60919 -3.91248 1.60919 0.0 +3228 3.65 2.75 86.25 3.58908 3.25589 -3.58908 -1.10369 -3.25589 1.10369 0.0 +3229 3.65 2.75 93.75 2.9762 2.39149 -2.9762 -0.808766 -2.39149 0.808766 0.0 +3230 3.65 2.75 101.25 2.36071 1.48535 -2.36071 -0.659115 -1.48535 0.659115 0.0 +3231 3.65 2.75 108.75 1.79777 0.671454 -1.79777 -0.545142 -0.671455 0.545142 0.0 +3232 3.65 2.75 116.25 1.28284 0.0234409 -1.28284 -0.404026 -0.0234405 0.404026 0.0 +3233 3.65 2.75 123.75 0.811743 -0.43038 -0.811744 -0.231178 0.43038 0.231178 0.0 +3234 3.65 2.75 131.25 0.396762 -0.692839 -0.396759 -0.0508027 0.692839 0.0508029 0.0 +3235 3.65 2.75 138.75 0.0525657 -0.79188 -0.0525663 0.112907 0.79188 -0.112907 0.0 +3236 3.65 2.75 146.25 -0.216914 -0.773428 0.216914 0.247559 0.773429 -0.247559 0.0 +3237 3.65 2.75 153.75 -0.418494 -0.689828 0.418494 0.351026 0.689828 -0.351026 0.0 +3238 3.65 2.75 161.25 -0.562315 -0.588117 0.562314 0.425709 0.588116 -0.425709 0.0 +3239 3.65 2.75 168.75 -0.655784 -0.50303 0.655784 0.474309 0.503029 -0.474309 0.0 +3240 3.65 2.75 176.25 -0.70215 -0.455711 0.702148 0.498348 0.45571 -0.498348 0.0 +3241 3.65 2.85 3.75 -36.1987 -22.1966 36.1987 67.8757 22.1966 -67.8757 0.0 +3242 3.65 2.85 11.25 -31.1231 -14.5476 31.1231 44.722 14.5476 -44.722 0.0 +3243 3.65 2.85 18.75 -22.9507 -4.83831 22.9507 25.1442 4.83831 -25.1442 0.0 +3244 3.65 2.85 26.25 -14.5015 1.99182 14.5015 14.4274 -1.99182 -14.4274 0.0 +3245 3.65 2.85 33.75 -7.74532 4.65105 7.74531 8.19298 -4.65105 -8.19298 0.0 +3246 3.65 2.85 41.25 -3.16789 4.58365 3.16789 3.66897 -4.58364 -3.66897 0.0 +3247 3.65 2.85 48.75 -0.326482 3.73795 0.326483 0.458076 -3.73795 -0.458076 0.0 +3248 3.65 2.85 56.25 1.38627 3.19238 -1.38627 -1.27721 -3.19238 1.27721 0.0 +3249 3.65 2.85 63.75 2.36943 3.06551 -2.36943 -1.75743 -3.06551 1.75743 0.0 +3250 3.65 2.85 71.25 2.8034 3.02746 -2.8034 -1.52065 -3.02746 1.52065 0.0 +3251 3.65 2.85 78.75 2.79373 2.78904 -2.79373 -1.08761 -2.78904 1.08761 0.0 +3252 3.65 2.85 86.25 2.48238 2.30604 -2.48238 -0.752322 -2.30604 0.752322 0.0 +3253 3.65 2.85 93.75 2.0349 1.7119 -2.0349 -0.569675 -1.71189 0.569675 0.0 +3254 3.65 2.85 101.25 1.56805 1.15837 -1.56805 -0.468524 -1.15836 0.468524 0.0 +3255 3.65 2.85 108.75 1.12682 0.726277 -1.12682 -0.371897 -0.726277 0.371897 0.0 +3256 3.65 2.85 116.25 0.721911 0.430298 -0.72191 -0.250757 -0.430296 0.250757 0.0 +3257 3.65 2.85 123.75 0.366105 0.255384 -0.366107 -0.115872 -0.255384 0.115872 0.0 +3258 3.65 2.85 131.25 0.0764133 0.178392 -0.0764139 0.0109956 -0.178395 -0.0109948 0.0 +3259 3.65 2.85 138.75 -0.140159 0.172548 0.140159 0.116179 -0.17255 -0.116179 0.0 +3260 3.65 2.85 146.25 -0.292185 0.208833 0.292184 0.197279 -0.208836 -0.197279 0.0 +3261 3.65 2.85 153.75 -0.396562 0.260566 0.396563 0.257879 -0.260565 -0.25788 0.0 +3262 3.65 2.85 161.25 -0.468221 0.308506 0.468223 0.301952 -0.308503 -0.301952 0.0 +3263 3.65 2.85 168.75 -0.515005 0.342587 0.515006 0.331407 -0.342587 -0.331407 0.0 +3264 3.65 2.85 176.25 -0.538677 0.359692 0.538675 0.346347 -0.359693 -0.346347 0.0 +3265 3.65 2.95 3.75 -31.0019 -19.003 31.0019 78.9744 19.003 -78.9744 0.0 +3266 3.65 2.95 11.25 -26.5858 -12.6408 26.5858 46.6915 12.6408 -46.6915 0.0 +3267 3.65 2.95 18.75 -19.2587 -4.5184 19.2587 22.835 4.51841 -22.835 0.0 +3268 3.65 2.95 26.25 -11.6633 1.10677 11.6633 11.5723 -1.10677 -11.5723 0.0 +3269 3.65 2.95 33.75 -5.7939 3.11687 5.79389 6.11985 -3.11686 -6.11985 0.0 +3270 3.65 2.95 41.25 -2.12727 2.91559 2.12727 2.63537 -2.91559 -2.63537 0.0 +3271 3.65 2.95 48.75 -0.137034 2.26979 0.137037 0.297769 -2.26979 -0.297769 0.0 +3272 3.65 2.95 56.25 0.89062 1.99985 -0.89062 -0.897052 -1.99985 0.897051 0.0 +3273 3.65 2.95 63.75 1.43386 2.04765 -1.43386 -1.17926 -2.04765 1.17926 0.0 +3274 3.65 2.95 71.25 1.68765 2.07234 -1.68766 -0.985761 -2.07234 0.985761 0.0 +3275 3.65 2.95 78.75 1.70109 1.87698 -1.70109 -0.696346 -1.87698 0.696346 0.0 +3276 3.65 2.95 86.25 1.52434 1.50326 -1.52434 -0.494147 -1.50326 0.494147 0.0 +3277 3.65 2.95 93.75 1.24419 1.10746 -1.24419 -0.388517 -1.10746 0.388517 0.0 +3278 3.65 2.95 101.25 0.937154 0.808793 -0.937155 -0.318937 -0.808791 0.318936 0.0 +3279 3.65 2.95 108.75 0.642843 0.634786 -0.642845 -0.240126 -0.634789 0.240127 0.0 +3280 3.65 2.95 116.25 0.381776 0.554629 -0.381776 -0.145979 -0.554627 0.14598 0.0 +3281 3.65 2.95 123.75 0.17295 0.527744 -0.17295 -0.0522492 -0.527741 0.0522488 0.0 +3282 3.65 2.95 131.25 0.0288148 0.525341 -0.0288157 0.0261916 -0.525345 -0.0261907 0.0 +3283 3.65 2.95 138.75 -0.0549588 0.529738 0.054956 0.0850404 -0.529738 -0.0850411 0.0 +3284 3.65 2.95 146.25 -0.0972437 0.529758 0.0972444 0.128089 -0.52976 -0.128088 0.0 +3285 3.65 2.95 153.75 -0.119472 0.520003 0.119472 0.16087 -0.520002 -0.16087 0.0 +3286 3.65 2.95 161.25 -0.13538 0.501774 0.135382 0.186492 -0.501775 -0.186491 0.0 +3287 3.65 2.95 168.75 -0.14865 0.481932 0.148652 0.205017 -0.481933 -0.205016 0.0 +3288 3.65 2.95 176.25 -0.156808 0.469103 0.156808 0.214928 -0.469103 -0.214928 0.0 +3289 3.65 3.05 3.75 -23.5214 -12.7722 23.5214 89.7571 12.7722 -89.7571 0.0 +3290 3.65 3.05 11.25 -20.5344 -8.89321 20.5344 46.7329 8.89321 -46.7329 0.0 +3291 3.65 3.05 18.75 -14.9237 -3.37015 14.9237 19.602 3.37015 -19.602 0.0 +3292 3.65 3.05 26.25 -8.79497 0.654416 8.79497 8.53398 -0.654415 -8.53398 0.0 +3293 3.65 3.05 33.75 -4.08878 2.00814 4.08878 4.118 -2.00814 -4.118 0.0 +3294 3.65 3.05 41.25 -1.34433 1.73251 1.34433 1.70123 -1.73252 -1.70123 0.0 +3295 3.65 3.05 48.75 -0.0691392 1.25993 0.0691406 0.177071 -1.25993 -0.177071 0.0 +3296 3.65 3.05 56.25 0.448 1.16617 -0.448 -0.563897 -1.16617 0.563897 0.0 +3297 3.65 3.05 63.75 0.688998 1.28795 -0.688995 -0.713807 -1.28795 0.713807 0.0 +3298 3.65 3.05 71.25 0.832696 1.31773 -0.8327 -0.581497 -1.31773 0.581496 0.0 +3299 3.65 3.05 78.75 0.879329 1.14394 -0.879329 -0.412977 -1.14394 0.412977 0.0 +3300 3.65 3.05 86.25 0.814193 0.858734 -0.814194 -0.307966 -0.858731 0.307966 0.0 +3301 3.65 3.05 93.75 0.671971 0.610837 -0.671969 -0.25422 -0.610837 0.25422 0.0 +3302 3.65 3.05 101.25 0.504261 0.479465 -0.50426 -0.20887 -0.479465 0.208869 0.0 +3303 3.65 3.05 108.75 0.347065 0.452085 -0.347066 -0.151081 -0.452085 0.151081 0.0 +3304 3.65 3.05 116.25 0.223383 0.474397 -0.22338 -0.0866915 -0.474392 0.0866907 0.0 +3305 3.65 3.05 123.75 0.149325 0.499837 -0.149326 -0.0298693 -0.499834 0.0298677 0.0 +3306 3.65 3.05 131.25 0.12772 0.50528 -0.127719 0.0117782 -0.505278 -0.0117784 0.0 +3307 3.65 3.05 138.75 0.143881 0.48447 -0.143884 0.0399674 -0.484471 -0.0399662 0.0 +3308 3.65 3.05 146.25 0.173862 0.43953 -0.173863 0.0607343 -0.439532 -0.0607346 0.0 +3309 3.65 3.05 153.75 0.197949 0.377853 -0.197948 0.0788534 -0.377854 -0.0788529 0.0 +3310 3.65 3.05 161.25 0.208419 0.311516 -0.20842 0.0954852 -0.311516 -0.0954856 0.0 +3311 3.65 3.05 168.75 0.208396 0.255395 -0.208397 0.108907 -0.255394 -0.108908 0.0 +3312 3.65 3.05 176.25 0.205537 0.223214 -0.205539 0.116501 -0.223214 -0.116501 0.0 +3313 3.65 3.15 3.75 -13.9561 -3.3206 13.9561 98.2858 3.3206 -98.2858 0.0 +3314 3.65 3.15 11.25 -13.261 -3.34518 13.261 43.9082 3.34518 -43.9082 0.0 +3315 3.65 3.15 18.75 -10.2101 -1.48319 10.2101 15.6336 1.48319 -15.6336 0.0 +3316 3.65 3.15 26.25 -6.06397 0.541479 6.06397 5.68372 -0.541479 -5.68372 0.0 +3317 3.65 3.15 33.75 -2.6902 1.22634 2.69021 2.43562 -1.22634 -2.43562 0.0 +3318 3.65 3.15 41.25 -0.799622 0.922855 0.799619 0.965754 -0.922853 -0.965755 0.0 +3319 3.65 3.15 48.75 -0.0595567 0.587691 0.0595571 0.105055 -0.58769 -0.105055 0.0 +3320 3.65 3.15 56.25 0.136132 0.582762 -0.136135 -0.296388 -0.582762 0.296388 0.0 +3321 3.65 3.15 63.75 0.206081 0.714041 -0.20608 -0.369864 -0.714043 0.369864 0.0 +3322 3.65 3.15 71.25 0.291262 0.735392 -0.29126 -0.298228 -0.735391 0.298228 0.0 +3323 3.65 3.15 78.75 0.359948 0.594925 -0.359946 -0.219047 -0.594924 0.219047 0.0 +3324 3.65 3.15 86.25 0.364864 0.394363 -0.36487 -0.178439 -0.39436 0.178439 0.0 +3325 3.65 3.15 93.75 0.314697 0.253059 -0.314697 -0.158716 -0.253058 0.158716 0.0 +3326 3.65 3.15 101.25 0.247244 0.215305 -0.247245 -0.133797 -0.215307 0.133798 0.0 +3327 3.65 3.15 108.75 0.19353 0.249334 -0.193531 -0.0978249 -0.249331 0.0978237 0.0 +3328 3.65 3.15 116.25 0.172327 0.299349 -0.17233 -0.0603582 -0.299354 0.0603583 0.0 +3329 3.65 3.15 123.75 0.191601 0.327027 -0.191602 -0.0313905 -0.327024 0.0313885 0.0 +3330 3.65 3.15 131.25 0.244296 0.319239 -0.244294 -0.0132263 -0.319245 0.0132287 0.0 +3331 3.65 3.15 138.75 0.309669 0.277854 -0.309668 -0.00163962 -0.277858 0.00164223 0.0 +3332 3.65 3.15 146.25 0.36466 0.210708 -0.36466 0.00886413 -0.210705 -0.00886437 0.0 +3333 3.65 3.15 153.75 0.396038 0.12897 -0.396036 0.0210449 -0.128967 -0.0210456 0.0 +3334 3.65 3.15 161.25 0.404322 0.0468919 -0.404325 0.034161 -0.0468877 -0.0341657 0.0 +3335 3.65 3.15 168.75 0.399467 -0.0197308 -0.399467 0.0454309 0.0197332 -0.045432 0.0 +3336 3.65 3.15 176.25 0.393288 -0.0570915 -0.393287 0.0519376 0.0570948 -0.0519383 0.0 +3337 3.65 3.25 3.75 -2.84841 8.98913 2.84841 101.365 -8.98913 -101.365 0.0 +3338 3.65 3.25 11.25 -5.30559 3.68427 5.30559 37.2625 -3.68427 -37.2625 0.0 +3339 3.65 3.25 18.75 -5.47905 1.03572 5.47905 11.105 -1.03572 -11.105 0.0 +3340 3.65 3.25 26.25 -3.63301 0.745278 3.63301 3.27944 -0.745278 -3.27944 0.0 +3341 3.65 3.25 33.75 -1.61937 0.737373 1.61937 1.21149 -0.737371 -1.21149 0.0 +3342 3.65 3.25 41.25 -0.451827 0.424127 0.451828 0.462362 -0.424126 -0.462367 0.0 +3343 3.65 3.25 48.75 -0.0643465 0.186784 0.064344 0.0665433 -0.186787 -0.0665438 0.0 +3344 3.65 3.25 56.25 -0.0271963 0.206749 0.0271963 -0.112307 -0.206747 0.112306 0.0 +3345 3.65 3.25 63.75 -0.0287216 0.314739 0.0287221 -0.147725 -0.314739 0.147727 0.0 +3346 3.65 3.25 71.25 0.0255212 0.334405 -0.0255227 -0.121627 -0.334405 0.121627 0.0 +3347 3.65 3.25 78.75 0.0934406 0.242453 -0.0934401 -0.0975277 -0.242456 0.0975275 0.0 +3348 3.65 3.25 86.25 0.124558 0.11911 -0.12456 -0.0934047 -0.119111 0.0934046 0.0 +3349 3.65 3.25 93.75 0.120536 0.0466826 -0.12054 -0.0939133 -0.0466836 0.0939132 0.0 +3350 3.65 3.25 101.25 0.110584 0.0476725 -0.110584 -0.0847896 -0.0476712 0.0847891 0.0 +3351 3.65 3.25 108.75 0.117935 0.090861 -0.117936 -0.0672303 -0.0908671 0.0672311 0.0 +3352 3.65 3.25 116.25 0.153275 0.133648 -0.153275 -0.0500874 -0.133656 0.0500894 0.0 +3353 3.65 3.25 123.75 0.215727 0.151238 -0.215728 -0.0391482 -0.151235 0.0391465 0.0 +3354 3.65 3.25 131.25 0.291608 0.138189 -0.291609 -0.0336619 -0.13819 0.0336617 0.0 +3355 3.65 3.25 138.75 0.359347 0.0983875 -0.359348 -0.0291956 -0.0983892 0.0291967 0.0 +3356 3.65 3.25 146.25 0.401272 0.038616 -0.401271 -0.022058 -0.0386123 0.0220571 0.0 +3357 3.65 3.25 153.75 0.412585 -0.0321809 -0.412584 -0.0116292 0.0321862 0.0116272 0.0 +3358 3.65 3.25 161.25 0.401401 -0.1024 -0.401399 4.51052e-05 0.102401 -4.42202e-05 0.0 +3359 3.65 3.25 168.75 0.382258 -0.159045 -0.38226 0.00995287 0.159044 -0.00995344 0.0 +3360 3.65 3.25 176.25 0.368774 -0.190698 -0.368775 0.0155765 0.190695 -0.0155759 0.0 +3361 3.65 3.35 3.75 8.57831 22.029 -8.57831 90.4039 -22.029 -90.4039 0.0 +3362 3.65 3.35 11.25 2.48876 10.9716 -2.48876 25.2009 -10.9716 -25.2009 0.0 +3363 3.65 3.35 18.75 -1.10374 3.77841 1.10374 5.92447 -3.77841 -5.92447 0.0 +3364 3.65 3.35 26.25 -1.58014 1.17267 1.58014 1.35603 -1.17267 -1.35603 0.0 +3365 3.65 3.35 33.75 -0.82821 0.490495 0.828207 0.439289 -0.490495 -0.43929 0.0 +3366 3.65 3.35 41.25 -0.237349 0.172633 0.237344 0.163569 -0.172631 -0.163569 0.0 +3367 3.65 3.35 48.75 -0.0586032 0.00522448 0.0586023 0.0404713 -0.00522588 -0.0404716 0.0 +3368 3.65 3.35 56.25 -0.0692222 0.0153302 0.0692185 -0.0129308 -0.0153248 0.0129318 0.0 +3369 3.65 3.35 63.75 -0.0840586 0.0871098 0.0840552 -0.0309457 -0.0871098 0.0309442 0.0 +3370 3.65 3.35 71.25 -0.0536445 0.110943 0.0536423 -0.0295495 -0.110941 0.0295495 0.0 +3371 3.65 3.35 78.75 -0.00982277 0.0701621 0.00982661 -0.0305352 -0.0701671 0.0305349 0.0 +3372 3.65 3.35 86.25 0.0145461 0.0088837 -0.0145485 -0.0406569 -0.00888549 0.040657 0.0 +3373 3.65 3.35 93.75 0.0229469 -0.0252769 -0.0229444 -0.0491129 0.025273 0.0491132 0.0 +3374 3.65 3.35 101.25 0.0355738 -0.0188163 -0.0355749 -0.0488332 0.0188197 0.0488329 0.0 +3375 3.65 3.35 108.75 0.0655018 0.0101297 -0.0655002 -0.0435205 -0.0101327 0.0435213 0.0 +3376 3.65 3.35 116.25 0.115214 0.0376575 -0.115217 -0.0395796 -0.0376578 0.0395802 0.0 +3377 3.65 3.35 123.75 0.178049 0.0506336 -0.17805 -0.0391484 -0.0506349 0.0391483 0.0 +3378 3.65 3.35 131.25 0.238684 0.0459317 -0.238686 -0.0397537 -0.0459383 0.0397562 0.0 +3379 3.65 3.35 138.75 0.279372 0.0244903 -0.27937 -0.0377474 -0.0244898 0.0377484 0.0 +3380 3.65 3.35 146.25 0.29001 -0.0110173 -0.290012 -0.0314691 0.0110121 0.0314721 0.0 +3381 3.65 3.35 153.75 0.273314 -0.0554592 -0.273313 -0.0220115 0.0554597 0.0220096 0.0 +3382 3.65 3.35 161.25 0.241753 -0.100943 -0.241753 -0.0119952 0.100943 0.0119956 0.0 +3383 3.65 3.35 168.75 0.210527 -0.138246 -0.210527 -0.00397578 0.138246 0.0039749 0.0 +3384 3.65 3.35 176.25 0.191739 -0.15925 -0.191737 0.000392892 0.159255 -0.000394892 0.0 +3385 3.65 3.45 3.75 13.9352 25.0134 -13.9352 47.3581 -25.0134 -47.3581 0.0 +3386 3.65 3.45 11.25 6.6144 12.841 -6.6144 7.54163 -12.841 -7.54163 0.0 +3387 3.65 3.45 18.75 1.63977 4.65277 -1.63978 0.626067 -4.65277 -0.626067 0.0 +3388 3.65 3.45 26.25 -0.134965 1.26549 0.134964 -0.00630213 -1.26549 0.0063021 0.0 +3389 3.65 3.45 33.75 -0.257019 0.327565 0.257018 0.0506325 -0.327565 -0.0506314 0.0 +3390 3.65 3.45 41.25 -0.0878206 0.0755859 0.0878219 0.0249344 -0.0755854 -0.0249345 0.0 +3391 3.65 3.45 48.75 -0.0295997 -0.0171818 0.0296009 0.0154182 0.0171825 -0.0154176 0.0 +3392 3.65 3.45 56.25 -0.0349652 -0.0219445 0.0349652 0.0129602 0.0219435 -0.0129587 0.0 +3393 3.65 3.45 63.75 -0.0407381 0.00761187 0.0407386 0.00421853 -0.00761128 -0.00421831 0.0 +3394 3.65 3.45 71.25 -0.034214 0.0259423 0.0342165 7.51679e-05 -0.0259422 -7.45622e-05 0.0 +3395 3.65 3.45 78.75 -0.0246565 0.0206849 0.0246588 -0.00385973 -0.0206858 0.00385946 0.0 +3396 3.65 3.45 86.25 -0.0199608 0.00260566 0.0199588 -0.0108228 -0.00260582 0.0108228 0.0 +3397 3.65 3.45 93.75 -0.0160962 -0.0108235 0.0160951 -0.0154515 0.0108225 0.0154515 0.0 +3398 3.65 3.45 101.25 -0.00516199 -0.0109817 0.00516255 -0.0158667 0.0109834 0.015867 0.0 +3399 3.65 3.45 108.75 0.0161436 -0.000990441 -0.0161444 -0.0157139 0.000992657 0.0157131 0.0 +3400 3.65 3.45 116.25 0.0462359 0.0119933 -0.0462349 -0.0179074 -0.011993 0.0179074 0.0 +3401 3.65 3.45 123.75 0.0789796 0.0222832 -0.0789806 -0.0216543 -0.0222854 0.0216552 0.0 +3402 3.65 3.45 131.25 0.104194 0.0261517 -0.104194 -0.0240943 -0.02615 0.0240937 0.0 +3403 3.65 3.45 138.75 0.112387 0.02152 -0.112387 -0.0230795 -0.0215204 0.0230794 0.0 +3404 3.65 3.45 146.25 0.100783 0.00855296 -0.100781 -0.01859 -0.00855206 0.01859 0.0 +3405 3.65 3.45 153.75 0.0747866 -0.010086 -0.0747873 -0.0122934 0.0100866 0.0122928 0.0 +3406 3.65 3.45 161.25 0.0443158 -0.0300182 -0.0443169 -0.0062199 0.0300166 0.00622007 0.0 +3407 3.65 3.45 168.75 0.0188579 -0.0465341 -0.0188583 -0.00176027 0.0465354 0.00175935 0.0 +3408 3.65 3.45 176.25 0.0047077 -0.0558365 -0.0047082 0.000519921 0.055837 -0.000521264 0.0 +3409 3.65 3.55 3.75 9.08664 14.1707 -9.08664 5.00548 -14.1707 -5.00548 0.0 +3410 3.65 3.55 11.25 4.57491 7.32707 -4.57491 -2.27541 -7.32707 2.27541 0.0 +3411 3.65 3.55 18.75 1.46185 2.72587 -1.46185 -1.40671 -2.72587 1.40671 0.0 +3412 3.65 3.55 26.25 0.202401 0.72718 -0.2024 -0.363615 -0.72718 0.363615 0.0 +3413 3.65 3.55 33.75 -0.0292135 0.158386 0.029214 -0.0296083 -0.158386 0.0296077 0.0 +3414 3.65 3.55 41.25 -0.013327 0.0341023 0.0133271 0.000415071 -0.0341024 -0.000414506 0.0 +3415 3.65 3.55 48.75 -0.00386995 0.00137162 0.00387057 0.00354997 -0.00137196 -0.00354995 0.0 +3416 3.65 3.55 56.25 -0.00362953 -0.00381371 0.00363005 0.00491999 0.00381369 -0.00492036 0.0 +3417 3.65 3.55 63.75 -0.00367255 0.000623919 0.00367258 0.000772869 -0.000624073 -0.000773243 0.0 +3418 3.65 3.55 71.25 -0.00599085 0.00545353 0.00599175 -0.000877382 -0.00545427 0.000877255 0.0 +3419 3.65 3.55 78.75 -0.00914792 0.00752484 0.00914884 -0.00123739 -0.00752489 0.00123748 0.0 +3420 3.65 3.55 86.25 -0.0111926 0.00607339 0.0111914 -0.00180791 -0.00607396 0.00180784 0.0 +3421 3.65 3.55 93.75 -0.0109307 0.00306489 0.0109307 -0.00110181 -0.00306532 0.00110186 0.0 +3422 3.65 3.55 101.25 -0.0077646 0.00146913 0.00776434 0.000281463 -0.00146817 -0.000281676 0.0 +3423 3.65 3.55 108.75 -0.00177445 0.00282649 0.00177504 0.000276509 -0.00282655 -0.00027648 0.0 +3424 3.65 3.55 116.25 0.00630219 0.00656393 -0.00630239 -0.00161604 -0.0065638 0.00161557 0.0 +3425 3.65 3.55 123.75 0.0142754 0.0104985 -0.0142748 -0.00404929 -0.0104982 0.00404958 0.0 +3426 3.65 3.55 131.25 0.0185262 0.0121463 -0.0185258 -0.00537147 -0.0121454 0.00537123 0.0 +3427 3.65 3.55 138.75 0.016205 0.0102423 -0.0162052 -0.00485693 -0.0102423 0.00485692 0.0 +3428 3.65 3.55 146.25 0.00744851 0.00528258 -0.00744923 -0.00289648 -0.00528247 0.00289629 0.0 +3429 3.65 3.55 153.75 -0.0047483 -0.0011129 0.0047475 -0.000439985 0.00111111 0.000440653 0.0 +3430 3.65 3.55 161.25 -0.0165726 -0.00720789 0.0165725 0.00167706 0.00720864 -0.00167778 0.0 +3431 3.65 3.55 168.75 -0.0252959 -0.0117744 0.0252957 0.00306582 0.0117749 -0.00306615 0.0 +3432 3.65 3.55 176.25 -0.0297657 -0.0141745 0.0297651 0.00371221 0.0141748 -0.00371261 0.0 +3433 3.65 3.65 3.75 1.34179 1.8764 -1.34179 -2.21207 -1.8764 2.21207 0.0 +3434 3.65 3.65 11.25 0.674722 0.975627 -0.674722 -1.01114 -0.975627 1.01114 0.0 +3435 3.65 3.65 18.75 0.218094 0.365855 -0.218094 -0.384938 -0.365855 0.384938 0.0 +3436 3.65 3.65 26.25 0.034533 0.0959486 -0.034533 -0.0883541 -0.0959486 0.0883541 0.0 +3437 3.65 3.65 33.75 0.000906004 0.0183831 -0.000905993 -0.00778172 -0.0183832 0.00778172 0.0 +3438 3.65 3.65 41.25 0.00132048 0.00271731 -0.00132051 0.00071098 -0.00271729 -0.000710997 0.0 +3439 3.65 3.65 48.75 0.000821636 -0.000306112 -0.00082155 0.000743727 0.000306079 -0.000743719 0.0 +3440 3.65 3.65 56.25 0.00055949 -0.000894959 -0.000559485 0.000325653 0.000894939 -0.000325638 0.0 +3441 3.65 3.65 63.75 0.000919031 -0.00134167 -0.000918928 -0.000425567 0.0013417 0.000425618 0.0 +3442 3.65 3.65 71.25 0.00068388 -0.00161126 -0.000683975 -0.000595268 0.00161117 0.000595242 0.0 +3443 3.65 3.65 78.75 0.000214632 -0.00126472 -0.000214751 -0.000489084 0.00126474 0.000489099 0.0 +3444 3.65 3.65 86.25 8.67817e-06 -0.000701107 -8.75836e-06 -0.000274181 0.00070111 0.000274184 0.0 +3445 3.65 3.65 93.75 1.71384e-06 -0.000443281 -1.76788e-06 0.000154524 0.000443329 -0.000154528 0.0 +3446 3.65 3.65 101.25 1.95029e-05 -0.000477718 -1.95794e-05 0.000567489 0.000477841 -0.000567493 0.0 +3447 3.65 3.65 108.75 7.48783e-05 -0.00049436 -7.48748e-05 0.000683729 0.000494453 -0.000683746 0.0 +3448 3.65 3.65 116.25 0.000265232 -0.000391767 -0.000265328 0.00052426 0.000391822 -0.000524261 0.0 +3449 3.65 3.65 123.75 0.000509939 -0.000400182 -0.000509922 0.000310119 0.000400276 -0.000310147 0.0 +3450 3.65 3.65 131.25 0.000525607 -0.000787876 -0.000525615 0.000228989 0.000787858 -0.00022897 0.0 +3451 3.65 3.65 138.75 0.000108536 -0.00156718 -0.000108471 0.000330074 0.00156723 -0.000330079 0.0 +3452 3.65 3.65 146.25 -0.000640149 -0.00249673 0.000640125 0.000548861 0.00249673 -0.000548895 0.0 +3453 3.65 3.65 153.75 -0.0014021 -0.00329158 0.00140212 0.000784814 0.00329161 -0.000784826 0.0 +3454 3.65 3.65 161.25 -0.00190979 -0.00380299 0.00190977 0.000966445 0.00380303 -0.000966483 0.0 +3455 3.65 3.65 168.75 -0.00211603 -0.00404799 0.00211605 0.00107292 0.004048 -0.00107292 0.0 +3456 3.65 3.65 176.25 -0.00215132 -0.00412886 0.00215137 0.00111754 0.00412895 -0.00111757 0.0 diff --git a/examples/PACKAGES/pair_3b_table/CG-CG-CG.dist.new b/examples/PACKAGES/pair_3b_table/CG-CG-CG.dist.new new file mode 100644 index 0000000000..7009d77ec6 --- /dev/null +++ b/examples/PACKAGES/pair_3b_table/CG-CG-CG.dist.new @@ -0,0 +1,63 @@ +0 0 i +0.05 0 i +0.1 0 i +0.15 0 i +0.2 0 i +0.25 0 i +0.3 0 i +0.35 0 i +0.4 0 i +0.45 0 i +0.5 0 i +0.55 0 i +0.6 0 i +0.65 0 i +0.7 0.001948589708 i +0.75 0.04587304938 i +0.8 0.2676063199 i +0.85 0.5482844291 i +0.9 0.6484744166 i +0.95 0.6004903951 i +1 0.4988389653 i +1.05 0.4309630905 i +1.1 0.4329116802 i +1.15 0.4468765731 i +1.2 0.4768361398 i +1.25 0.4997320689 i +1.3 0.5256320738 i +1.35 0.5270935161 i +1.4 0.5542925807 i +1.45 0.5859571635 i +1.5 0.5850640599 i +1.55 0.5951317734 i +1.6 0.6080411802 i +1.65 0.6103145349 i +1.7 0.6252537226 i +1.75 0.6264715912 i +1.8 0.6312618742 i +1.85 0.6111264472 i +1.9 0.5870938408 i +1.95 0.5864443109 i +2 0.5615186009 i +2.05 0.5516944611 i +2.1 0.5181624799 i +2.15 0.5016806586 i +2.2 0.4791906857 i +2.25 0.4356721823 i +2.3 0.4166734326 i +2.35 0.4014906711 i +2.4 0.3701508533 i +2.45 0.3518016336 i +2.5 0.32533329 i +2.55 0.3129922219 i +2.6 0.2849812448 i +2.65 0.2464965981 i +2.7 0.2347238686 i +2.75 0.1968887518 i +2.8 0.1679846711 i +2.85 0.1487423477 i +2.9 0.115372749 i +2.95 0.0894727441 i +3 0.0654401377 i +3.05 0.04424922462 i +3.1 0.02127210431 i diff --git a/examples/PACKAGES/pair_3b_table/CG-CG.dist.new b/examples/PACKAGES/pair_3b_table/CG-CG.dist.new new file mode 100644 index 0000000000..20086f12e2 --- /dev/null +++ b/examples/PACKAGES/pair_3b_table/CG-CG.dist.new @@ -0,0 +1,301 @@ +0 0 i +0.05 0 i +0.1 0 i +0.15 0 i +0.2 0 i +0.25 0 i +0.3 0 i +0.35 0 i +0.4 0 i +0.45 0 i +0.5 0 i +0.55 0 i +0.6 0 i +0.65 0 i +0.7 0 i +0.75 0 i +0.8 0 i +0.85 0 i +0.9 0 i +0.95 0 i +1 0 i +1.05 0 i +1.1 0 i +1.15 0 i +1.2 0 i +1.25 0 i +1.3 0 i +1.35 0 i +1.4 0 i +1.45 0 i +1.5 0 i +1.55 0 i +1.6 0 i +1.65 0 i +1.7 0 i +1.75 0 i +1.8 0 i +1.85 0 i +1.9 0 i +1.95 0 i +2 0 i +2.05 0 i +2.1 0 i +2.15 0 i +2.2 0 i +2.25 0 i +2.3 0 i +2.35 0 i +2.4 0 i +2.45 0.006868969636 i +2.5 0.06691209899 i +2.55 0.3369686231 i +2.6 1.016837547 i +2.65 1.941722496 i +2.7 2.810156047 i +2.75 3.109238091 i +2.8 2.992426567 i +2.85 2.654848044 i +2.9 2.142463942 i +2.95 1.78347485 i +3 1.474515791 i +3.05 1.214450999 i +3.1 1.145558566 i +3.15 1.05605496 i +3.2 0.9416308652 i +3.25 0.9061891875 i +3.3 0.8518932332 i +3.35 0.8345267201 i +3.4 0.7974243251 i +3.45 0.7759630924 i +3.5 0.8025159274 i +3.55 0.7814715757 i +3.6 0.8367247283 i +3.65 0.8466756241 i +3.7 0.8260987595 i +3.75 0.8875703499 i +3.8 0.8908815678 i +3.85 0.8893512455 i +3.9 0.9034838101 i +3.95 0.975136055 i +4 0.9693174253 i +4.05 0.9333220268 i +4.1 0.9786753242 i +4.15 1.02432124 i +4.2 0.9877232079 i +4.25 1.042558817 i +4.3 1.016224537 i +4.35 1.041869238 i +4.4 1.064875454 i +4.45 1.028884843 i +4.5 1.030581768 i +4.55 1.048458215 i +4.6 1.089257872 i +4.65 1.094290276 i +4.7 1.084997348 i +4.75 1.070629827 i +4.8 1.084744429 i +4.85 1.082526933 i +4.9 1.06079278 i +4.95 1.0471637 i +5 1.062609545 i +5.05 1.040979202 i +5.1 1.030405966 i +5.15 1.010273278 i +5.2 1.023613984 i +5.25 0.9909597269 i +5.3 1.015757348 i +5.35 1.006532346 i +5.4 0.9437414066 i +5.45 0.961407175 i +5.5 0.9391385986 i +5.55 0.9337672098 i +5.6 0.9434633573 i +5.65 0.9427075195 i +5.7 0.9256975468 i +5.75 0.969172923 i +5.8 0.9108617596 i +5.85 0.9316750162 i +5.9 0.9343951559 i +5.95 0.9320676092 i +6 0.9648657983 i +6.05 0.9452822858 i +6.1 0.9782890038 i +6.15 0.9800447499 i +6.2 1.000311384 i +6.25 0.9763785285 i +6.3 1.003683553 i +6.35 0.9945134274 i +6.4 1.018437926 i +6.45 1.022248288 i +6.5 1.016480477 i +6.55 1.022988268 i +6.6 1.012956154 i +6.65 1.03627509 i +6.7 1.053539045 i +6.75 1.033851978 i +6.8 1.030805888 i +6.85 1.025729717 i +6.9 1.050384748 i +6.95 1.025204169 i +7 1.032609309 i +7.05 1.03922794 i +7.1 1.029667001 i +7.15 1.034097295 i +7.2 0.9966052515 i +7.25 0.998595277 i +7.3 1.020333466 i +7.35 1.012277485 i +7.4 1.008970678 i +7.45 0.9878317879 i +7.5 1.022664977 i +7.55 1.017638075 i +7.6 0.9861398784 i +7.65 1.015262635 i +7.7 1.001623523 i +7.75 1.003549644 i +7.8 0.9805591545 i +7.85 1.007394142 i +7.9 0.9803367825 i +7.95 0.9888274034 i +8 0.9665658006 i +8.05 0.9611406547 i +8.1 0.9696011841 i +8.15 0.9612879559 i +8.2 0.9740415393 i +8.25 0.9570782131 i +8.3 0.970292395 i +8.35 0.9968930245 i +8.4 1.002925264 i +8.45 0.9971135902 i +8.5 0.9944668799 i +8.55 0.9901215978 i +8.6 0.9963226014 i +8.65 1.002471928 i +8.7 0.9972859678 i +8.75 1.000461709 i +8.8 1.007456373 i +8.85 0.9975337886 i +8.9 1.006881375 i +8.95 1.003898668 i +9 1.01939082 i +9.05 1.027863733 i +9.1 1.0126874 i +9.15 1.002986797 i +9.2 1.014592881 i +9.25 0.996218997 i +9.3 1.01434386 i +9.35 1.009318782 i +9.4 1.002409715 i +9.45 1.00752861 i +9.5 1.003738731 i +9.55 1.00546252 i +9.6 1.004475552 i +9.65 1.01401835 i +9.7 0.9999605344 i +9.75 0.9928909486 i +9.8 0.9909424428 i +9.85 0.9900750302 i +9.9 0.9919391121 i +9.95 0.9982970715 i +10 0.9898116624 i +10.05 0.9900764439 i +10.1 0.9969278915 i +10.15 0.9995371762 i +10.2 0.9830245195 i +10.25 0.9985185237 i +10.3 1.011778325 i +10.35 0.987729726 i +10.4 0.9792899029 i +10.45 1.005757012 i +10.5 1.011427913 i +10.55 1.01826943 i +10.6 1.018069644 i +10.65 1.009052089 i +10.7 1.012454415 i +10.75 1.014373714 i +10.8 1.003033618 i +10.85 1.00581897 i +10.9 0.9943814535 i +10.95 0.9987325036 i +11 0.9983875703 i +11.05 1.00760791 i +11.1 1.002375405 i +11.15 1.019653897 i +11.2 1.012683264 i +11.25 1.011799775 i +11.3 0.9985755313 i +11.35 1.004657344 i +11.4 1.011546083 i +11.45 1.006280333 i +11.5 0.9938523349 i +11.55 0.9903439726 i +11.6 0.9903610229 i +11.65 0.9993250672 i +11.7 1.000612865 i +11.75 0.985843493 i +11.8 0.9935396204 i +11.85 0.9961212519 i +11.9 0.9881008469 i +11.95 0.9912340172 i +12 0.9932581399 i +12.05 1.005031664 i +12.1 1.000283189 i +12.15 0.9957382812 i +12.2 0.9905217757 i +12.25 1.005650661 i +12.3 0.9983867528 i +12.35 1.008547414 i +12.4 1.004989106 i +12.45 1.011715734 i +12.5 1.003525112 i +12.55 0.9923659728 i +12.6 0.9925939594 i +12.65 0.993670768 i +12.7 1.006897619 i +12.75 0.9910443316 i +12.8 1.003773488 i +12.85 1.003254426 i +12.9 1.003173391 i +12.95 1.003485179 i +13 0.9982555554 i +13.05 0.9907591011 i +13.1 0.9928898602 i +13.15 0.9995581937 i +13.2 1.004068838 i +13.25 1.001772811 i +13.3 1.002046922 i +13.35 1.000603255 i +13.4 1.011323585 i +13.45 1.009060732 i +13.5 1.013946339 i +13.55 1.005578858 i +13.6 0.9982940357 i +13.65 1.003923923 i +13.7 1.010292528 i +13.75 1.004609556 i +13.8 0.9928580994 i +13.85 1.003973204 i +13.9 0.99837917 i +13.95 0.9980455921 i +14 0.9986529903 i +14.05 0.9917965086 i +14.1 1.00095185 i +14.15 0.9970089013 i +14.2 0.997098635 i +14.25 0.9980037804 i +14.3 1.013908132 i +14.35 1.001934888 i +14.4 1.006664102 i +14.45 0.991726169 i +14.5 0.9912580833 i +14.55 1.008190614 i +14.6 0.9970967502 i +14.65 0.9958736094 i +14.7 0.9903643889 i +14.75 0.9965217067 i +14.8 0.998001776 i +14.85 1.000587917 i +14.9 0.9950512374 i +14.95 0.9958385369 i +15 1.001436413 i diff --git a/examples/PACKAGES/pair_3b_table/README b/examples/PACKAGES/pair_3b_table/README new file mode 100644 index 0000000000..d01c00afdd --- /dev/null +++ b/examples/PACKAGES/pair_3b_table/README @@ -0,0 +1,65 @@ +Example for pair style 3b/table + + +This example contains all required input files for the simulation of CG SPC/E water with +the user pair style 3b/table, as well as a run.sh script. + +To run the example, you have to compile LAMMPS with the MANYBODY package, including pair_3b_table.h and pair_3b_table.cpp. + +Running the simulations, you will reproduce results of the following publication: + +C. Scherer, R. Scheid, D. Andrienko, and T. Bereau, Kernel-Based Machine Learning for Efficient Simulations of Molecular Liquids, J. Chem. Theor. Comp., 16(5):3194–3204, 2020, https://doi.org/10.1021/acs.jctc.9b01256 + +Here, a water molecule is represented by one coarse-grained (CG) bead. The example contains +two parts. +The three-body (force) tables for both parts (1-1-1.table and 1-1-2.table) have been parametrized with the kernel-based machine learning (ML) with the VOTCA package (https://gitlab.mpcdf.mpg.de/votca/votca). +For a general description of the table format have a look at the documentation of this pair style. +For a example on the parametrization, have a look at https://gitlab.mpcdf.mpg.de/votca/votca/-/tree/master/csg-examples/guide and +https://gitlab.mpcdf.mpg.de/votca/votca/-/tree/master/csg-examples/ml. +In both cases, the parametrization has been done according to the three-body forces of the FM tabulated Stillinger-Weber (sw/3b/table) potential with the covariant meshing technique with the settings files used in https://gitlab.mpcdf.mpg.de/votca/votca/-/tree/master/csg-examples/ml/3body/with_binning. + +For the first part of example, the folder contains the contains the LAMMPS data file (spce.data) with the starting configuration of 1000 CG water molecules, an input file (spce.in) and a three-body file (spce.3b). + +The lammps input file contains the lines specifying the pair style and coefficients: + +- pair_style hybrid/overlay table linear 1200 3b/table - use a combination of pair style table with 1200 linear table entries and the pair style 3b/table +- pair_coeff 1 1 table table_CG_CG.txt VOTCA - set the table name and keyword for the pair style table +- pair_coeff * * 3b/table spce.3b type - set the name of 3body file and bead type for the pair style 3b/table + +A hybrid pair style is used, where pair forces are calculated as a tabulated interaction (table_CG_CG.txt) and the pair style 3b/table is only used to calculate the three-body forces. +The tabulated pair interaction is the same as in the example of the sw/3b/table pair style: examples/PACKAGES/pair_sw_3b_table + +To run the simulation, one needs an additional 3body file (spce.3b). +It has the following structure: + +- type - relates to keyword type in LAMMPS input file +- type - relates to keyword type in LAMMPS input file +- type - relates to keyword type in LAMMPS input file +- 3.7 - cutoff in Ang +- 1-1-1.table - name of 3-body force table +- ENTRY1 - keyword in 3-body force table for this interaction +- linear - interpolation is linear +- 12 - number of grid points in radial direction (automatically sets grid size, in this case to 1872) + +As there is only one atom type (1), the force table is symmetric and contains "M = N * N * (N+1)" (12 * 12 * 13 = 1872) entries. + +The LAMMPS simulation is a standard nvt simulation. A dump file is output with the positions and forces every 10 time steps. +You can calculate the pair distribution and compare it to the ones in the publication. + +For the second part of the example, have a look at the LAMMPS data file (spce_2.data), the input file (spce_2.in) and the three-body file (spce_2.3b). +Running the second part, you will in fact perform the same MD simulation as in the first part of the example. However, the atom type of the first 100 CG water molecules has been changed from 1 to 2. +This is done to demonstrate how to run a simulation with different atom types. + +Again, lammps input file (spce_2.in) contains the lines specifying the pair style and coefficients: + +- pair_style hybrid/overlay table linear 1200 3b/table - use a combination of pair style table with 1200 linear table entries and the pair style 3b/table +- pair_coeff 1 1 table table_CG_CG.txt VOTCA - set the table name and keyword for the pair style table +- pair_coeff * * 3b/table spce_2.3b type1 type2 - set the name of 3body file and bead type for the pair style 3b/table + +Now, the atom type 1 is mapped to the element type1 and the atom type 2 is mapped to the element type2 in the 3body file (spce_2.3b). +For this (artificial) two-element simulation, the 3body file now contain 8 entries for: type1 type1 type1, type1 type1 type2, type1 type2 type1, type1 type2 type2, type2 type1 type1, type2 type1 type2, type2 type2 type1, type2 type2 type2. +Each entry has the same structure as above. However, entries where the second and the third element are different require a different force table (1-1-2.table) instead of (1-1-1.table). +1-1-2.table contains exactly the force constants as 1-1-1.table. +However it has to have the asymmetric structure where both interparticle distances (r_ij and r_ik) are varied from rmin to rmax and therefore contains "M = 2 * N * N * N" (2 * 12 * 12 * 12 = 3456) entries. + +Now run the simulation. The theromodynamic output, as well as, the pair correlation function should be exactly the same as for the first part of the example. diff --git a/examples/PACKAGES/pair_3b_table/calculate_distributions.xml b/examples/PACKAGES/pair_3b_table/calculate_distributions.xml new file mode 100644 index 0000000000..f2510d4f21 --- /dev/null +++ b/examples/PACKAGES/pair_3b_table/calculate_distributions.xml @@ -0,0 +1,29 @@ + + + grid + + + + + CG-CG + 1 + 1 + 0.0 + 15.0 + 0.05 + + + + + + CG-CG-CG + 1 + 1 + 1 + 1 + 0.0 + 3.1 + 0.05 + 3.7 + + diff --git a/examples/PACKAGES/pair_3b_table/run.sh b/examples/PACKAGES/pair_3b_table/run.sh new file mode 100755 index 0000000000..c87c01e23e --- /dev/null +++ b/examples/PACKAGES/pair_3b_table/run.sh @@ -0,0 +1,8 @@ +#! /bin/bash -e + +#run the LAMMPS simulation of the first part of the tutorial (needs a current LAMMPS version compiled with the user pair_style 3b/table) +lmp < spce.in > spce.out + +#run the LAMMPS simulation of the second part of the tutorial (needs a current LAMMPS version compiled with the user pair_style 3b/table) +lmp < spce_2.in > spce_2.out + diff --git a/examples/PACKAGES/pair_3b_table/spce.3b b/examples/PACKAGES/pair_3b_table/spce.3b new file mode 100644 index 0000000000..07f9b66433 --- /dev/null +++ b/examples/PACKAGES/pair_3b_table/spce.3b @@ -0,0 +1,8 @@ +type +type +type +3.7 # cut in Ang +1-1-1.table +ENTRY1 +linear +12 diff --git a/examples/PACKAGES/pair_3b_table/spce.data b/examples/PACKAGES/pair_3b_table/spce.data new file mode 100644 index 0000000000..a56ab1b10c --- /dev/null +++ b/examples/PACKAGES/pair_3b_table/spce.data @@ -0,0 +1,1015 @@ +Data File for CG Water + +1000 atoms +1 atom types + +0 31.0648 xlo xhi +0 31.0648 ylo yhi +0 31.0648 zlo zhi + +Masses + +1 18.0154 + +Atoms + +1 1 18.26 24.7 15.77 +2 1 12.63 1.42 27.01 +3 1 10.39 29.11 13.56 +4 1 26.47 16.64 7.23 +5 1 10.66 23.41 27.33 +6 1 19.08 3.2 21.63 +7 1 11.17 26.19 1.44 +8 1 4.61 4.04 25.72 +9 1 4.61 22.91 8.33 +10 1 30.61 22.71 25.18 +11 1 6.38 18.92 16.87 +12 1 17.83 12.53 11.09 +13 1 14.89 2.43 22.44 +14 1 28.36 30.9 26.38 +15 1 25.73 28.56 8.32 +16 1 19.61 20.22 4.43 +17 1 25.96 30.32 24.22 +18 1 14.51 17.35 16.41 +19 1 30.23 17.26 10.71 +20 1 22.68 23.23 2.3 +21 1 10.89 15.76 14.33 +22 1 1.46 20.46 12.48 +23 1 12.73 19.57 2.71 +24 1 1.21 12.02 9.88 +25 1 2.63 14.4 23.71 +26 1 16.91 20.37 4.73 +27 1 28.02 7.7 30.08 +28 1 21.22 22.47 19.66 +29 1 14.0 28.15 0.14 +30 1 19.62 19.73 1.11 +31 1 28.29 24.36 10.15 +32 1 14.05 1.1 17.64 +33 1 12.2 23.75 24.83 +34 1 24.56 26.02 13.57 +35 1 12.13 8.39 7.17 +36 1 20.47 22.28 25.02 +37 1 11.06 7.63 24.11 +38 1 6.52 22.64 30.46 +39 1 16.51 24.78 18.58 +40 1 30.18 20.56 29.19 +41 1 25.26 7.8 25.98 +42 1 20.37 4.16 3.88 +43 1 18.85 27.34 27.83 +44 1 17.72 29.84 12.78 +45 1 19.26 14.48 19.38 +46 1 29.73 4.46 4.96 +47 1 9.52 26.27 30.33 +48 1 6.55 9.25 20.32 +49 1 10.49 1.91 23.31 +50 1 17.63 1.17 14.48 +51 1 1.56 25.17 4.69 +52 1 9.08 10.39 2.29 +53 1 25.92 7.4 21.53 +54 1 25.3 5.14 28.4 +55 1 5.63 23.26 19.85 +56 1 9.6 9.85 24.85 +57 1 3.32 2.77 9.12 +58 1 28.54 15.28 22.18 +59 1 20.45 8.24 18.25 +60 1 12.86 3.73 11.61 +61 1 7.42 12.05 13.54 +62 1 1.73 28.54 25.27 +63 1 3.25 22.18 23.7 +64 1 3.27 25.38 2.24 +65 1 13.46 15.67 19.28 +66 1 31.0 6.91 13.61 +67 1 4.85 27.3 12.67 +68 1 24.48 13.52 4.98 +69 1 23.93 29.62 19.71 +70 1 5.03 13.35 19.5 +71 1 24.58 13.46 19.59 +72 1 7.42 6.82 9.03 +73 1 28.76 15.1 3.33 +74 1 12.38 17.21 6.63 +75 1 15.75 21.23 27.02 +76 1 4.58 5.06 28.19 +77 1 26.04 23.3 25.38 +78 1 30.02 7.27 9.52 +79 1 6.93 10.03 24.54 +80 1 5.61 26.93 27.34 +81 1 29.12 19.12 5.54 +82 1 18.44 27.8 14.75 +83 1 14.1 23.13 9.78 +84 1 24.12 5.55 20.72 +85 1 2.52 10.99 18.44 +86 1 1.76 6.41 21.47 +87 1 25.22 9.56 30.66 +88 1 11.87 13.25 9.12 +89 1 19.46 0.3 22.07 +90 1 28.82 12.29 11.36 +91 1 28.47 30.29 14.09 +92 1 25.51 20.94 24.33 +93 1 1.14 25.4 8.76 +94 1 1.33 27.98 3.09 +95 1 20.57 26.97 -0.04 +96 1 22.73 1.18 0.62 +97 1 19.16 16.99 30.52 +98 1 0.39 9.65 9.02 +99 1 4.41 7.21 3.22 +100 1 11.07 30.64 25.91 +101 1 7.93 25.84 26.26 +102 1 26.76 2.51 2.93 +103 1 30.8 18.15 18.49 +104 1 10.2 7.46 30.44 +105 1 4.77 20.39 26.99 +106 1 25.27 26.77 1.64 +107 1 28.51 13.99 9.33 +108 1 13.86 8.04 24.9 +109 1 30.67 29.88 23.01 +110 1 29.49 30.58 30.02 +111 1 28.74 5.08 30.95 +112 1 13.21 4.31 30.96 +113 1 5.27 3.66 5.02 +114 1 29.43 7.99 17.07 +115 1 4.19 1.37 16.63 +116 1 1.27 27.81 16.56 +117 1 30.64 5.73 25.91 +118 1 10.33 5.33 26.48 +119 1 11.56 21.77 14.77 +120 1 26.46 27.17 5.7 +121 1 14.85 25.79 8.64 +122 1 22.62 6.18 17.61 +123 1 3.45 18.53 11.84 +124 1 11.65 18.17 15.97 +125 1 23.16 17.0 1.5 +126 1 18.92 16.01 3.98 +127 1 30.05 0.25 5.23 +128 1 26.06 11.96 21.96 +129 1 16.82 2.0 10.25 +130 1 19.58 2.63 24.75 +131 1 20.09 14.75 26.62 +132 1 3.14 0.05 26.13 +133 1 4.86 11.79 12.99 +134 1 1.86 11.32 28.57 +135 1 8.82 28.6 6.22 +136 1 20.85 24.68 23.87 +137 1 7.58 25.15 3.44 +138 1 23.46 9.13 8.11 +139 1 6.45 10.24 27.37 +140 1 15.06 10.35 26.71 +141 1 13.8 18.39 26.5 +142 1 5.11 7.7 5.83 +143 1 23.27 23.16 6.67 +144 1 6.33 1.31 11.37 +145 1 14.66 22.28 21.43 +146 1 7.9 8.65 0.61 +147 1 21.83 3.67 26.17 +148 1 1.41 23.66 11.09 +149 1 10.19 17.23 22.71 +150 1 29.53 27.31 23.19 +151 1 28.69 11.38 2.33 +152 1 1.07 2.97 14.53 +153 1 23.47 30.53 14.32 +154 1 1.59 18.83 14.75 +155 1 20.38 30.6 24.38 +156 1 19.81 29.95 27.9 +157 1 12.68 27.59 26.46 +158 1 20.46 9.14 29.06 +159 1 8.69 13.98 24.71 +160 1 0.72 9.29 30.28 +161 1 11.81 20.55 12.28 +162 1 23.8 13.8 9.4 +163 1 13.63 0.51 0.95 +164 1 2.33 6.68 14.95 +165 1 15.98 6.35 25.28 +166 1 7.38 14.88 18.44 +167 1 17.07 20.48 29.16 +168 1 14.53 1.49 8.4 +169 1 28.45 1.21 20.58 +170 1 0.07 5.28 29.45 +171 1 26.0 9.98 15.37 +172 1 14.56 6.91 14.46 +173 1 20.6 9.09 23.04 +174 1 26.02 4.59 0.14 +175 1 5.21 21.9 17.55 +176 1 2.44 7.72 1.47 +177 1 1.25 30.0 13.48 +178 1 27.27 23.13 14.61 +179 1 24.04 15.61 21.64 +180 1 25.13 5.24 17.43 +181 1 4.2 15.98 12.34 +182 1 26.92 13.54 12.87 +183 1 3.38 19.38 9.08 +184 1 27.75 25.03 2.15 +185 1 26.13 20.68 16.54 +186 1 8.3 14.6 13.49 +187 1 3.04 22.87 29.93 +188 1 9.5 26.41 21.23 +189 1 6.53 2.16 2.75 +190 1 6.37 29.04 2.63 +191 1 26.58 4.38 19.69 +192 1 28.44 6.56 14.66 +193 1 25.55 11.1 28.03 +194 1 25.5 18.39 28.73 +195 1 27.67 23.47 5.65 +196 1 13.69 14.81 16.17 +197 1 22.97 27.61 24.11 +198 1 2.06 18.58 30.22 +199 1 2.07 7.13 29.2 +200 1 13.0 7.26 17.76 +201 1 10.04 16.22 30.62 +202 1 6.54 9.8 17.47 +203 1 5.65 12.68 0.64 +204 1 20.84 20.25 23.02 +205 1 22.48 27.63 21.48 +206 1 15.61 22.73 5.36 +207 1 3.52 30.36 6.24 +208 1 6.38 17.25 26.36 +209 1 14.13 10.57 22.63 +210 1 10.22 25.11 3.64 +211 1 16.63 14.7 25.08 +212 1 3.51 29.69 2.76 +213 1 19.2 11.9 21.44 +214 1 30.8 23.85 14.75 +215 1 21.02 14.34 12.4 +216 1 2.75 22.13 27.29 +217 1 29.27 14.29 6.8 +218 1 8.44 20.67 5.23 +219 1 9.42 20.06 22.95 +220 1 30.83 10.64 19.73 +221 1 19.33 14.14 8.94 +222 1 14.18 11.32 18.19 +223 1 26.55 2.39 28.55 +224 1 6.83 16.57 8.9 +225 1 13.98 8.79 1.97 +226 1 4.94 3.0 23.16 +227 1 25.39 29.46 0.63 +228 1 15.32 16.43 2.45 +229 1 5.26 29.73 29.87 +230 1 26.92 14.84 19.93 +231 1 11.87 30.08 4.52 +232 1 7.17 6.71 2.23 +233 1 10.46 1.13 18.11 +234 1 28.59 20.57 25.68 +235 1 26.54 4.84 8.44 +236 1 16.46 18.37 26.15 +237 1 30.53 0.74 15.31 +238 1 27.25 6.31 27.09 +239 1 22.42 1.65 3.87 +240 1 17.85 3.77 8.02 +241 1 11.82 8.23 11.15 +242 1 8.62 27.66 15.87 +243 1 25.19 1.89 18.37 +244 1 14.0 21.96 30.21 +245 1 29.3 1.73 28.29 +246 1 9.35 24.02 12.03 +247 1 1.05 21.5 0.35 +248 1 21.87 20.54 2.54 +249 1 10.59 15.98 17.51 +250 1 22.76 6.0 9.32 +251 1 0.31 9.13 11.87 +252 1 29.16 25.13 18.29 +253 1 1.23 29.08 7.75 +254 1 30.01 28.49 26.21 +255 1 1.87 5.92 5.03 +256 1 1.15 10.27 22.35 +257 1 11.83 10.31 5.16 +258 1 20.89 8.28 8.14 +259 1 13.48 11.78 28.37 +260 1 6.82 10.48 10.25 +261 1 7.34 4.49 18.73 +262 1 5.49 22.37 14.23 +263 1 12.31 21.05 27.47 +264 1 24.09 17.4 8.65 +265 1 22.03 11.54 20.98 +266 1 16.68 13.17 0.68 +267 1 5.52 1.47 8.78 +268 1 14.95 11.83 7.95 +269 1 5.9 10.66 7.12 +270 1 10.06 11.28 30.73 +271 1 17.72 10.71 27.46 +272 1 13.6 6.23 10.82 +273 1 23.42 30.72 9.31 +274 1 23.27 4.25 3.8 +275 1 13.79 8.37 21.07 +276 1 5.01 30.13 12.61 +277 1 26.04 24.45 17.25 +278 1 22.59 14.31 0.81 +279 1 23.74 10.37 17.17 +280 1 23.4 8.52 12.55 +281 1 10.53 23.97 21.96 +282 1 0.69 13.92 28.42 +283 1 6.94 6.27 15.01 +284 1 29.8 20.92 3.41 +285 1 10.19 20.68 19.0 +286 1 26.38 25.4 28.89 +287 1 12.34 26.9 8.27 +288 1 15.0 7.69 6.4 +289 1 24.75 13.1 2.24 +290 1 4.5 20.58 6.78 +291 1 23.27 18.25 11.48 +292 1 25.92 26.39 22.66 +293 1 24.63 4.21 6.52 +294 1 16.68 15.05 15.6 +295 1 26.39 16.17 29.89 +296 1 10.12 6.21 8.63 +297 1 14.41 14.67 12.23 +298 1 19.59 3.47 1.47 +299 1 28.21 22.43 18.25 +300 1 27.87 29.74 11.47 +301 1 22.53 24.1 13.94 +302 1 12.55 1.58 29.82 +303 1 17.45 21.28 8.34 +304 1 16.3 10.75 16.22 +305 1 16.34 13.25 17.65 +306 1 8.44 4.52 0.93 +307 1 17.47 23.79 2.3 +308 1 29.04 26.8 5.13 +309 1 13.13 11.34 24.9 +310 1 24.33 13.0 13.32 +311 1 8.21 29.74 24.23 +312 1 21.79 28.0 5.85 +313 1 13.74 20.08 10.26 +314 1 20.92 24.38 6.01 +315 1 9.83 29.56 17.99 +316 1 26.66 30.76 2.95 +317 1 24.34 3.08 1.67 +318 1 28.09 10.69 23.33 +319 1 7.08 25.28 0.77 +320 1 15.34 1.12 29.82 +321 1 26.07 12.55 7.74 +322 1 16.85 0.81 21.24 +323 1 9.96 0.57 6.36 +324 1 29.4 2.54 1.18 +325 1 5.81 1.0 5.42 +326 1 25.16 24.89 11.15 +327 1 15.43 24.93 13.71 +328 1 24.6 10.06 10.58 +329 1 20.4 12.04 15.51 +330 1 15.72 18.9 0.21 +331 1 16.5 17.21 28.81 +332 1 16.79 3.11 12.74 +333 1 22.75 6.22 6.6 +334 1 8.09 19.86 30.92 +335 1 24.15 8.75 23.65 +336 1 12.24 30.51 15.39 +337 1 8.15 26.8 18.69 +338 1 0.1 15.0 15.49 +339 1 29.84 15.71 30.0 +340 1 15.39 18.25 11.17 +341 1 1.2 15.49 18.8 +342 1 27.55 9.81 17.9 +343 1 18.93 8.9 10.06 +344 1 28.35 12.36 4.82 +345 1 11.21 13.71 30.62 +346 1 2.5 16.67 16.33 +347 1 0.47 4.2 6.99 +348 1 23.72 4.38 12.28 +349 1 16.59 3.54 16.9 +350 1 17.31 17.81 15.8 +351 1 11.58 0.3 21.21 +352 1 23.67 21.91 15.84 +353 1 7.74 2.78 23.52 +354 1 14.34 9.65 4.52 +355 1 23.35 10.88 14.55 +356 1 3.51 10.03 20.99 +357 1 14.63 21.34 1.75 +358 1 24.37 8.39 2.96 +359 1 14.8 15.5 30.48 +360 1 2.59 1.32 12.76 +361 1 0.16 13.81 25.49 +362 1 11.26 10.11 27.84 +363 1 27.8 18.65 15.07 +364 1 5.07 5.43 21.33 +365 1 14.06 5.26 19.67 +366 1 3.76 18.23 19.36 +367 1 26.68 27.25 10.67 +368 1 7.72 19.58 13.64 +369 1 29.48 16.94 16.45 +370 1 28.18 13.38 30.28 +371 1 29.97 10.41 16.17 +372 1 11.97 28.73 29.31 +373 1 14.88 0.79 25.43 +374 1 8.98 23.85 7.66 +375 1 4.78 8.21 9.79 +376 1 21.74 20.61 28.64 +377 1 20.36 18.75 17.92 +378 1 12.61 21.65 23.18 +379 1 6.36 29.76 8.49 +380 1 12.51 26.69 18.69 +381 1 22.2 17.41 6.86 +382 1 11.7 6.53 21.66 +383 1 4.62 16.22 3.24 +384 1 0.76 13.73 0.83 +385 1 21.91 13.43 5.67 +386 1 17.36 6.16 4.12 +387 1 0.34 28.1 11.89 +388 1 2.43 26.92 20.47 +389 1 0.99 22.41 4.14 +390 1 23.77 24.66 24.16 +391 1 22.41 7.79 20.57 +392 1 16.4 22.82 23.46 +393 1 24.68 28.28 17.44 +394 1 14.99 26.21 27.12 +395 1 0.75 13.41 7.7 +396 1 16.43 5.69 21.09 +397 1 19.5 6.71 27.89 +398 1 14.32 17.4 22.9 +399 1 29.04 27.81 19.17 +400 1 9.52 19.68 10.69 +401 1 5.33 27.17 17.3 +402 1 5.2 12.64 9.11 +403 1 9.8 6.14 19.74 +404 1 9.86 22.71 1.2 +405 1 0.84 12.31 14.9 +406 1 18.79 12.07 17.76 +407 1 27.21 25.79 14.27 +408 1 6.11 1.01 19.83 +409 1 8.44 5.68 12.85 +410 1 22.42 26.4 1.81 +411 1 24.0 20.11 18.63 +412 1 2.32 26.11 12.18 +413 1 26.06 7.28 15.77 +414 1 9.96 9.13 19.49 +415 1 10.74 12.01 25.79 +416 1 30.39 1.07 11.77 +417 1 9.49 20.19 26.63 +418 1 15.99 30.59 6.78 +419 1 11.0 30.74 0.96 +420 1 23.67 30.14 22.75 +421 1 24.14 9.9 19.82 +422 1 5.88 5.5 7.25 +423 1 3.45 10.72 9.52 +424 1 11.78 25.26 29.31 +425 1 15.95 27.28 17.71 +426 1 17.99 16.5 8.95 +427 1 28.47 0.47 23.29 +428 1 14.06 1.39 12.17 +429 1 19.28 23.85 8.27 +430 1 13.62 4.42 14.21 +431 1 2.98 9.89 12.04 +432 1 7.35 14.53 10.79 +433 1 15.55 0.87 3.17 +434 1 7.7 24.24 23.88 +435 1 17.61 8.64 6.93 +436 1 5.17 26.9 3.74 +437 1 1.06 17.17 27.8 +438 1 18.8 9.64 19.81 +439 1 8.36 1.64 0.63 +440 1 13.68 14.97 7.75 +441 1 29.56 0.55 17.98 +442 1 3.01 24.45 14.3 +443 1 11.98 7.48 26.92 +444 1 19.13 24.44 27.57 +445 1 11.75 14.57 11.88 +446 1 13.1 4.54 22.64 +447 1 7.2 21.26 28.21 +448 1 24.85 22.96 28.77 +449 1 15.0 23.95 16.32 +450 1 24.6 14.43 15.56 +451 1 3.05 13.66 17.69 +452 1 3.0 3.39 6.37 +453 1 24.92 22.04 13.42 +454 1 21.24 2.56 17.68 +455 1 19.69 0.3 11.75 +456 1 5.73 29.89 26.41 +457 1 7.62 30.1 0.37 +458 1 14.62 28.23 20.86 +459 1 8.72 5.14 23.94 +460 1 9.94 25.78 9.45 +461 1 17.3 4.53 0.74 +462 1 17.58 12.58 14.58 +463 1 8.64 2.55 20.15 +464 1 21.07 10.96 26.32 +465 1 27.85 4.23 10.9 +466 1 20.41 29.07 20.84 +467 1 9.35 12.65 10.7 +468 1 9.88 0.73 3.41 +469 1 26.64 20.78 1.33 +470 1 25.47 19.72 10.96 +471 1 1.01 5.01 12.19 +472 1 10.11 27.98 23.8 +473 1 17.51 0.24 28.51 +474 1 21.85 14.89 8.07 +475 1 18.22 12.88 29.4 +476 1 10.97 16.02 2.55 +477 1 4.3 25.33 5.86 +478 1 12.67 27.62 3.28 +479 1 12.18 24.26 16.74 +480 1 0.24 29.32 20.41 +481 1 5.03 15.5 6.14 +482 1 11.11 12.43 6.7 +483 1 10.14 4.47 15.0 +484 1 2.9 6.91 24.11 +485 1 30.6 4.29 16.4 +486 1 9.61 4.66 29.44 +487 1 5.38 17.6 1.1 +488 1 3.71 5.22 11.92 +489 1 8.93 11.33 8.19 +490 1 31.02 28.82 0.48 +491 1 0.81 2.74 23.14 +492 1 16.45 28.36 8.16 +493 1 2.1 8.36 17.2 +494 1 25.82 16.89 1.44 +495 1 20.21 11.2 11.56 +496 1 13.88 23.42 27.01 +497 1 30.15 5.56 2.54 +498 1 1.76 17.51 24.41 +499 1 18.18 8.62 16.29 +500 1 4.41 20.18 15.26 +501 1 7.05 29.39 19.64 +502 1 22.92 21.56 26.41 +503 1 29.43 3.25 12.91 +504 1 16.92 25.1 29.07 +505 1 25.4 12.48 17.22 +506 1 7.4 5.74 28.39 +507 1 0.14 3.32 27.06 +508 1 29.61 24.31 3.76 +509 1 13.25 25.77 23.43 +510 1 19.18 28.02 24.33 +511 1 3.66 10.37 26.9 +512 1 12.53 11.26 1.28 +513 1 28.21 7.27 11.49 +514 1 26.9 9.35 3.39 +515 1 18.87 28.09 9.36 +516 1 9.3 30.5 15.62 +517 1 12.34 13.23 3.13 +518 1 27.93 26.52 26.46 +519 1 7.78 9.29 14.0 +520 1 16.12 6.82 1.73 +521 1 0.63 2.82 20.33 +522 1 12.2 26.56 13.2 +523 1 6.16 16.1 15.43 +524 1 13.49 24.29 6.85 +525 1 28.61 10.73 30.64 +526 1 19.98 17.97 5.68 +527 1 2.75 19.83 4.73 +528 1 18.41 26.18 2.29 +529 1 22.35 24.43 11.05 +530 1 4.45 4.92 15.13 +531 1 16.8 18.43 21.99 +532 1 2.08 4.57 24.87 +533 1 26.03 2.02 24.82 +534 1 15.65 30.12 19.2 +535 1 27.88 13.79 27.66 +536 1 29.03 7.86 2.9 +537 1 2.68 5.55 9.4 +538 1 30.45 11.98 23.35 +539 1 2.08 19.71 21.15 +540 1 11.06 3.11 4.38 +541 1 21.61 14.28 20.83 +542 1 15.85 5.82 12.29 +543 1 29.7 22.61 8.47 +544 1 29.5 7.81 27.38 +545 1 24.12 20.22 0.4 +546 1 16.0 25.22 21.34 +547 1 19.8 25.24 13.43 +548 1 7.11 16.71 4.39 +549 1 4.59 0.13 21.8 +550 1 20.94 12.01 28.92 +551 1 12.99 2.09 6.04 +552 1 19.45 19.38 14.86 +553 1 12.98 23.9 12.88 +554 1 13.06 12.04 20.67 +555 1 17.56 1.18 25.76 +556 1 29.88 16.58 1.42 +557 1 6.04 13.87 25.34 +558 1 25.5 6.08 10.63 +559 1 20.34 11.15 2.51 +560 1 3.82 11.92 15.57 +561 1 10.47 18.64 8.01 +562 1 13.02 24.92 20.67 +563 1 20.03 29.78 7.22 +564 1 8.36 11.63 28.63 +565 1 14.06 21.56 15.74 +566 1 9.4 28.78 29.81 +567 1 9.07 10.18 22.15 +568 1 11.47 22.66 29.81 +569 1 17.02 8.02 27.19 +570 1 29.56 18.32 21.38 +571 1 8.58 8.58 11.23 +572 1 22.15 19.86 15.25 +573 1 12.34 29.83 7.16 +574 1 20.52 25.35 20.66 +575 1 21.23 5.6 23.05 +576 1 23.45 10.69 5.93 +577 1 14.15 4.81 4.29 +578 1 8.26 24.58 28.88 +579 1 10.03 3.4 7.88 +580 1 25.65 7.23 0.84 +581 1 7.28 26.7 9.09 +582 1 20.47 29.31 16.02 +583 1 4.44 7.7 27.1 +584 1 27.95 23.13 0.39 +585 1 19.82 18.98 12.12 +586 1 20.01 5.07 14.72 +587 1 1.66 1.23 5.19 +588 1 5.6 11.21 22.59 +589 1 3.81 22.68 4.63 +590 1 17.47 14.06 22.25 +591 1 16.77 22.61 10.71 +592 1 7.2 26.5 22.52 +593 1 10.75 17.97 28.76 +594 1 16.61 8.28 20.88 +595 1 0.81 27.72 28.37 +596 1 6.78 22.71 4.37 +597 1 27.35 28.79 17.13 +598 1 15.16 3.34 2.07 +599 1 19.69 29.89 30.66 +600 1 17.34 20.23 2.18 +601 1 15.65 15.76 9.8 +602 1 19.07 19.02 8.23 +603 1 26.13 0.42 7.37 +604 1 4.29 9.29 15.94 +605 1 7.86 7.42 4.84 +606 1 23.4 1.93 16.16 +607 1 5.27 27.16 0.17 +608 1 27.08 14.52 1.58 +609 1 8.34 11.25 18.53 +610 1 10.4 17.83 12.7 +611 1 8.86 18.1 18.73 +612 1 17.69 22.57 26.0 +613 1 6.1 6.61 11.68 +614 1 24.32 13.38 23.99 +615 1 0.13 20.78 22.53 +616 1 10.96 20.82 6.33 +617 1 28.46 1.62 7.03 +618 1 16.9 4.13 23.44 +619 1 1.89 11.75 5.82 +620 1 3.27 20.91 2.26 +621 1 11.14 15.5 24.78 +622 1 21.76 3.5 20.99 +623 1 3.95 12.22 24.49 +624 1 7.26 23.31 16.11 +625 1 19.28 20.97 21.06 +626 1 7.2 17.22 22.12 +627 1 16.26 10.81 24.17 +628 1 1.54 24.72 17.86 +629 1 17.74 0.11 1.5 +630 1 25.85 5.87 23.82 +631 1 4.21 7.73 13.47 +632 1 20.87 8.0 25.94 +633 1 22.23 3.22 8.98 +634 1 13.72 30.72 23.05 +635 1 4.91 26.26 19.85 +636 1 14.82 27.52 13.76 +637 1 27.5 3.72 26.36 +638 1 27.62 9.82 10.27 +639 1 19.32 8.78 3.53 +640 1 16.33 28.86 1.39 +641 1 30.26 10.13 4.93 +642 1 14.94 29.37 4.67 +643 1 7.61 12.27 21.0 +644 1 5.31 18.92 23.16 +645 1 25.19 3.1 14.51 +646 1 8.12 21.6 9.56 +647 1 20.35 17.71 23.89 +648 1 3.39 19.78 24.7 +649 1 5.42 23.52 1.93 +650 1 29.44 5.52 23.47 +651 1 23.83 22.25 20.16 +652 1 17.93 4.41 19.13 +653 1 9.44 1.91 29.19 +654 1 29.91 23.65 12.09 +655 1 27.06 21.35 3.96 +656 1 16.28 19.92 14.78 +657 1 19.99 5.38 17.54 +658 1 14.54 21.16 7.89 +659 1 26.09 14.97 10.68 +660 1 0.63 24.05 28.89 +661 1 5.07 25.73 10.62 +662 1 6.78 8.27 29.12 +663 1 11.86 12.77 15.67 +664 1 21.83 14.26 24.49 +665 1 23.7 1.53 6.32 +666 1 28.91 27.7 13.19 +667 1 16.46 28.92 23.22 +668 1 26.22 15.29 23.65 +669 1 23.75 1.5 21.21 +670 1 4.08 23.38 11.4 +671 1 29.4 29.73 2.7 +672 1 8.94 16.2 27.64 +673 1 30.79 23.65 6.33 +674 1 27.04 17.6 10.45 +675 1 21.48 15.71 29.11 +676 1 17.68 22.29 18.33 +677 1 22.1 29.54 1.71 +678 1 16.17 27.33 3.65 +679 1 9.22 5.24 5.71 +680 1 1.81 4.91 1.83 +681 1 30.98 28.61 5.42 +682 1 0.24 6.26 18.55 +683 1 17.39 24.85 11.97 +684 1 28.21 20.4 22.88 +685 1 23.01 8.35 29.39 +686 1 4.03 15.76 25.76 +687 1 3.89 12.75 4.32 +688 1 16.42 9.73 9.22 +689 1 14.74 17.01 13.68 +690 1 11.65 22.66 10.77 +691 1 21.04 26.56 25.76 +692 1 3.97 29.83 10.01 +693 1 10.62 26.12 25.57 +694 1 17.97 8.53 23.31 +695 1 19.22 16.46 13.24 +696 1 2.39 24.13 25.42 +697 1 1.72 21.99 14.71 +698 1 14.16 25.55 4.52 +699 1 10.58 12.26 13.38 +700 1 25.76 29.55 5.46 +701 1 24.18 1.25 26.8 +702 1 30.61 26.16 30.37 +703 1 3.38 16.05 28.52 +704 1 1.18 24.43 20.96 +705 1 7.9 1.26 25.66 +706 1 26.57 10.39 5.82 +707 1 8.44 8.09 16.34 +708 1 16.67 27.55 25.72 +709 1 7.45 2.82 7.35 +710 1 19.18 19.09 28.22 +711 1 12.68 8.88 30.58 +712 1 27.98 26.24 30.75 +713 1 11.84 28.3 20.75 +714 1 10.45 30.97 11.14 +715 1 8.96 2.33 11.92 +716 1 7.66 10.26 5.22 +717 1 23.5 12.98 28.85 +718 1 30.48 8.08 21.02 +719 1 16.48 29.96 10.33 +720 1 13.88 5.72 8.08 +721 1 27.47 28.22 21.47 +722 1 26.74 18.07 22.5 +723 1 25.13 23.78 0.9 +724 1 29.21 15.71 26.07 +725 1 19.41 3.92 10.58 +726 1 24.96 7.64 5.7 +727 1 7.44 14.1 29.85 +728 1 7.13 12.21 3.18 +729 1 16.35 14.7 4.18 +730 1 1.43 15.6 11.58 +731 1 30.27 1.93 9.17 +732 1 2.77 2.54 27.69 +733 1 11.36 27.83 16.39 +734 1 7.83 2.36 14.66 +735 1 19.3 12.28 5.63 +736 1 28.36 12.19 19.25 +737 1 10.67 7.34 13.62 +738 1 26.6 24.47 21.0 +739 1 8.55 29.42 27.3 +740 1 25.79 25.13 4.07 +741 1 28.21 8.09 22.88 +742 1 22.44 11.07 23.78 +743 1 27.76 17.89 25.74 +744 1 2.23 0.19 23.48 +745 1 10.49 12.99 20.29 +746 1 18.74 11.84 24.74 +747 1 29.46 2.69 24.54 +748 1 3.11 29.29 15.2 +749 1 21.8 19.07 20.45 +750 1 11.21 17.26 20.08 +751 1 2.59 26.55 26.79 +752 1 23.67 25.82 17.79 +753 1 23.43 27.91 15.08 +754 1 6.86 2.11 28.13 +755 1 14.38 19.97 19.61 +756 1 29.05 26.41 8.62 +757 1 3.34 9.63 6.81 +758 1 21.41 30.88 18.45 +759 1 30.35 16.75 23.77 +760 1 19.92 6.73 20.92 +761 1 26.4 1.5 11.47 +762 1 16.6 8.88 30.96 +763 1 23.25 29.76 4.34 +764 1 17.15 13.45 7.34 +765 1 14.52 14.34 23.37 +766 1 11.77 3.31 25.06 +767 1 15.52 25.25 0.94 +768 1 21.53 27.39 12.97 +769 1 11.29 10.11 17.38 +770 1 11.07 15.06 5.47 +771 1 27.61 7.39 6.07 +772 1 15.82 4.83 27.63 +773 1 17.16 20.28 12.25 +774 1 3.18 28.03 22.92 +775 1 25.53 27.61 25.22 +776 1 1.81 16.55 1.25 +777 1 3.72 16.82 7.97 +778 1 7.68 21.57 2.11 +779 1 21.85 26.93 28.36 +780 1 10.31 8.57 4.0 +781 1 11.61 9.88 14.35 +782 1 0.41 8.48 24.13 +783 1 3.8 10.63 30.74 +784 1 2.74 17.0 21.82 +785 1 28.44 22.73 28.74 +786 1 2.08 0.43 20.23 +787 1 0.25 9.36 2.02 +788 1 27.68 11.33 26.53 +789 1 27.63 4.1 14.74 +790 1 19.68 0.89 3.22 +791 1 17.12 30.74 17.17 +792 1 16.11 25.62 24.01 +793 1 20.49 9.58 13.85 +794 1 26.77 20.78 27.64 +795 1 18.77 16.87 25.93 +796 1 7.01 13.49 6.76 +797 1 18.38 16.84 18.4 +798 1 8.54 14.44 4.51 +799 1 11.51 1.42 8.98 +800 1 17.06 14.93 12.29 +801 1 6.07 0.24 15.08 +802 1 8.76 17.53 2.01 +803 1 19.63 6.58 1.71 +804 1 10.24 4.66 10.93 +805 1 4.39 20.15 30.88 +806 1 30.31 16.7 6.24 +807 1 26.0 30.16 27.34 +808 1 6.44 21.42 21.88 +809 1 22.05 29.62 11.43 +810 1 21.94 22.11 9.22 +811 1 21.82 1.59 13.13 +812 1 27.09 0.55 16.64 +813 1 8.88 3.09 17.06 +814 1 6.95 18.85 6.3 +815 1 20.13 2.53 15.07 +816 1 17.52 12.36 3.26 +817 1 18.46 7.24 13.99 +818 1 12.61 6.94 3.36 +819 1 15.55 17.46 19.11 +820 1 16.13 27.37 11.33 +821 1 2.99 14.41 9.34 +822 1 5.81 22.26 24.67 +823 1 19.82 2.53 6.19 +824 1 28.93 5.65 7.69 +825 1 17.89 22.05 15.68 +826 1 5.63 7.81 23.81 +827 1 19.09 16.3 22.05 +828 1 1.07 19.82 27.06 +829 1 14.74 8.15 28.71 +830 1 16.98 10.27 4.92 +831 1 13.39 20.01 5.47 +832 1 21.23 3.56 30.15 +833 1 29.23 18.12 28.24 +834 1 16.76 24.31 7.29 +835 1 26.12 21.8 21.5 +836 1 0.2 13.1 12.25 +837 1 1.99 3.78 30.39 +838 1 26.67 20.02 19.27 +839 1 20.63 10.01 5.91 +840 1 4.44 3.74 1.84 +841 1 21.95 6.78 0.24 +842 1 9.86 22.51 17.05 +843 1 26.17 7.64 18.91 +844 1 17.09 20.11 19.78 +845 1 10.38 9.07 9.16 +846 1 9.92 13.21 17.39 +847 1 24.26 19.17 3.05 +848 1 13.32 18.96 29.06 +849 1 27.98 20.32 7.7 +850 1 10.35 6.44 17.04 +851 1 27.27 28.95 29.77 +852 1 7.71 19.32 24.95 +853 1 23.11 17.51 14.39 +854 1 25.37 14.39 26.26 +855 1 4.73 3.99 17.92 +856 1 28.53 17.74 8.3 +857 1 28.99 9.49 7.65 +858 1 11.37 3.77 18.66 +859 1 11.01 23.57 6.0 +860 1 7.29 17.47 30.27 +861 1 18.92 10.24 0.36 +862 1 22.76 24.44 27.3 +863 1 14.27 13.05 5.04 +864 1 3.42 14.59 30.9 +865 1 9.31 22.34 24.75 +866 1 25.78 16.96 15.63 +867 1 7.18 22.01 12.25 +868 1 5.0 18.29 28.57 +869 1 23.36 20.87 22.7 +870 1 13.16 10.8 10.17 +871 1 6.42 24.78 7.47 +872 1 28.86 3.89 20.92 +873 1 4.8 3.05 13.07 +874 1 27.07 3.53 5.63 +875 1 13.11 28.33 23.92 +876 1 14.84 13.88 20.8 +877 1 15.81 7.0 16.91 +878 1 23.41 25.39 20.56 +879 1 26.08 0.43 14.19 +880 1 6.28 17.41 19.28 +881 1 2.74 4.79 19.54 +882 1 20.98 26.42 10.11 +883 1 24.18 28.48 29.18 +884 1 12.74 29.99 12.8 +885 1 27.22 16.82 18.13 +886 1 2.08 19.98 18.27 +887 1 22.0 23.67 17.16 +888 1 17.83 3.01 29.13 +889 1 9.59 26.62 13.51 +890 1 11.48 2.18 13.45 +891 1 13.57 15.29 26.47 +892 1 1.72 0.72 9.92 +893 1 2.14 30.76 17.27 +894 1 17.9 15.88 1.47 +895 1 13.47 5.84 28.76 +896 1 8.96 22.14 21.0 +897 1 12.96 24.15 0.94 +898 1 26.13 23.25 8.89 +899 1 6.01 28.65 6.08 +900 1 22.88 20.21 6.1 +901 1 30.34 20.77 10.49 +902 1 12.19 28.16 10.6 +903 1 5.8 5.33 30.84 +904 1 29.83 26.29 15.91 +905 1 18.28 0.14 5.58 +906 1 1.91 17.34 5.88 +907 1 24.05 18.42 22.53 +908 1 10.82 21.55 3.57 +909 1 11.29 26.73 5.6 +910 1 21.34 14.41 3.22 +911 1 12.61 18.99 24.17 +912 1 25.02 18.6 25.9 +913 1 29.0 21.05 13.14 +914 1 17.72 27.28 30.27 +915 1 30.56 24.81 23.12 +916 1 17.09 20.05 24.02 +917 1 7.35 6.83 21.31 +918 1 3.39 22.32 21.05 +919 1 2.28 29.8 30.23 +920 1 5.29 25.66 14.8 +921 1 26.16 30.72 21.04 +922 1 21.63 6.32 11.68 +923 1 15.45 18.06 4.65 +924 1 5.76 28.33 24.04 +925 1 15.08 29.21 16.09 +926 1 18.76 6.14 6.94 +927 1 22.31 30.25 26.46 +928 1 18.49 22.04 30.93 +929 1 11.15 16.42 9.89 +930 1 4.34 7.98 30.25 +931 1 9.29 29.92 8.58 +932 1 22.97 27.09 8.04 +933 1 20.71 16.7 15.75 +934 1 30.36 7.49 5.24 +935 1 29.56 19.54 0.83 +936 1 30.71 14.04 20.91 +937 1 19.36 4.06 27.14 +938 1 23.41 10.8 2.14 +939 1 1.51 1.32 0.44 +940 1 8.16 14.39 1.63 +941 1 20.66 6.74 4.62 +942 1 20.78 26.26 3.85 +943 1 5.11 15.12 21.64 +944 1 12.53 20.03 17.67 +945 1 28.63 18.4 12.56 +946 1 1.95 21.69 8.08 +947 1 21.53 0.93 7.84 +948 1 2.69 22.51 17.17 +949 1 19.29 22.12 6.05 +950 1 23.68 2.14 11.01 +951 1 27.14 17.8 3.72 +952 1 2.22 14.81 3.31 +953 1 23.1 6.43 14.62 +954 1 0.22 12.59 3.57 +955 1 13.21 22.86 3.67 +956 1 13.45 2.1 20.14 +957 1 12.52 17.12 0.46 +958 1 3.07 27.45 9.03 +959 1 15.33 10.95 11.78 +960 1 0.05 4.26 9.75 +961 1 23.05 16.98 24.69 +962 1 16.15 16.28 6.51 +963 1 30.05 28.87 9.61 +964 1 6.67 29.5 16.95 +965 1 21.95 14.44 14.94 +966 1 22.58 22.47 30.33 +967 1 21.34 19.29 9.9 +968 1 29.31 21.79 20.79 +969 1 5.55 2.56 30.23 +970 1 25.88 3.17 22.22 +971 1 22.38 18.32 30.08 +972 1 6.27 19.24 8.86 +973 1 0.34 24.29 1.49 +974 1 20.49 24.13 0.25 +975 1 2.94 1.41 2.74 +976 1 24.88 25.38 7.35 +977 1 28.18 14.89 14.6 +978 1 7.84 30.36 4.39 +979 1 14.54 9.59 14.4 +980 1 27.63 12.3 15.83 +981 1 11.15 14.17 27.97 +982 1 25.27 20.88 8.35 +983 1 17.06 14.76 27.78 +984 1 3.9 14.79 15.06 +985 1 13.81 3.82 17.03 +986 1 28.55 24.1 26.15 +987 1 29.28 21.79 15.76 +988 1 15.05 30.12 27.83 +989 1 15.42 3.77 6.76 +990 1 22.65 12.12 11.24 +991 1 11.29 4.96 2.18 +992 1 2.15 7.43 7.57 +993 1 30.21 10.13 26.21 +994 1 24.42 22.18 4.42 +995 1 8.68 14.72 22.08 +996 1 23.1 6.9 27.1 +997 1 18.71 27.2 21.72 +998 1 14.12 12.7 30.76 +999 1 18.81 6.5 10.98 +1000 1 26.66 15.4 4.83 diff --git a/examples/PACKAGES/pair_3b_table/spce.in b/examples/PACKAGES/pair_3b_table/spce.in new file mode 100644 index 0000000000..c5b72c4f9a --- /dev/null +++ b/examples/PACKAGES/pair_3b_table/spce.in @@ -0,0 +1,43 @@ +log none + +units real +atom_style atomic + +read_data spce.data + +#hybrid pair style consisting of +#pair_style table to read in CG pair potential +#pair_style 3b/table for tabulated 3b interactions +pair_style hybrid/overlay table linear 1200 3b/table + +#pair coefficients +pair_coeff 1 1 table table_CG_CG.txt VOTCA +pair_coeff * * 3b/table spce.3b type + +#nvt run with nose-hoover thermostat +#time coupling of 100 ts for thermostat +#target T is 300 K +fix 1 all nvt temp 300.0 300.0 200.0 + +#create initial velocities +velocity all create 300 432567 dist uniform +#remove center of mass linear momentum +velocity all zero linear + +#remove center of mass linear momentum every 1000 time steps in each cartesian direction +fix remove all momentum 1000 linear 1 1 1 + +#timestep of 2 fs +timestep 2.0 + +#print out thermodynamic info every 100 ts +thermo 100 + +#run 10000 ts +run 10000 + +#write out dump file every 10 ts for 100000 ts +dump 2 all custom 10 spce.dump id type x y z fx fy fz +run 100000 + +undump 2 diff --git a/examples/PACKAGES/pair_3b_table/spce_2.3b b/examples/PACKAGES/pair_3b_table/spce_2.3b new file mode 100644 index 0000000000..52fcd1e5e9 --- /dev/null +++ b/examples/PACKAGES/pair_3b_table/spce_2.3b @@ -0,0 +1,71 @@ +type1 +type1 +type1 +3.7 # cut in Ang +1-1-1.table +ENTRY1 +linear +12 +type1 +type1 +type2 +3.7 # cut in Ang +1-1-2.table +ENTRY1 +linear +12 +type1 +type2 +type1 +3.7 # cut in Ang +1-1-2.table +ENTRY1 +linear +12 +type1 +type2 +type2 +3.7 # cut in Ang +1-1-1.table +ENTRY1 +linear +12 +type2 +type1 +type1 +3.7 # cut in Ang +1-1-1.table +ENTRY1 +linear +12 +type2 +type1 +type2 +3.7 # cut in Ang +1-1-2.table +ENTRY1 +linear +12 +type2 +type2 +type1 +3.7 # cut in Ang +1-1-2.table +ENTRY1 +linear +12 +type2 +type2 +type2 +3.7 # cut in Ang +1-1-1.table +ENTRY1 +linear +12 + + + + + + + diff --git a/examples/PACKAGES/pair_3b_table/spce_2.data b/examples/PACKAGES/pair_3b_table/spce_2.data new file mode 100644 index 0000000000..a0dbff24e5 --- /dev/null +++ b/examples/PACKAGES/pair_3b_table/spce_2.data @@ -0,0 +1,1016 @@ +Data File for CG Water + +1000 atoms +2 atom types + +0 31.0648 xlo xhi +0 31.0648 ylo yhi +0 31.0648 zlo zhi + +Masses + +1 18.0154 +2 18.0154 + +Atoms + +1 2 18.26 24.7 15.77 +2 2 12.63 1.42 27.01 +3 2 10.39 29.11 13.56 +4 2 26.47 16.64 7.23 +5 2 10.66 23.41 27.33 +6 2 19.08 3.2 21.63 +7 2 11.17 26.19 1.44 +8 2 4.61 4.04 25.72 +9 2 4.61 22.91 8.33 +10 2 30.61 22.71 25.18 +11 2 6.38 18.92 16.87 +12 2 17.83 12.53 11.09 +13 2 14.89 2.43 22.44 +14 2 28.36 30.9 26.38 +15 2 25.73 28.56 8.32 +16 2 19.61 20.22 4.43 +17 2 25.96 30.32 24.22 +18 2 14.51 17.35 16.41 +19 2 30.23 17.26 10.71 +20 2 22.68 23.23 2.3 +21 2 10.89 15.76 14.33 +22 2 1.46 20.46 12.48 +23 2 12.73 19.57 2.71 +24 2 1.21 12.02 9.88 +25 2 2.63 14.4 23.71 +26 2 16.91 20.37 4.73 +27 2 28.02 7.7 30.08 +28 2 21.22 22.47 19.66 +29 2 14.0 28.15 0.14 +30 2 19.62 19.73 1.11 +31 2 28.29 24.36 10.15 +32 2 14.05 1.1 17.64 +33 2 12.2 23.75 24.83 +34 2 24.56 26.02 13.57 +35 2 12.13 8.39 7.17 +36 2 20.47 22.28 25.02 +37 2 11.06 7.63 24.11 +38 2 6.52 22.64 30.46 +39 2 16.51 24.78 18.58 +40 2 30.18 20.56 29.19 +41 2 25.26 7.8 25.98 +42 2 20.37 4.16 3.88 +43 2 18.85 27.34 27.83 +44 2 17.72 29.84 12.78 +45 2 19.26 14.48 19.38 +46 2 29.73 4.46 4.96 +47 2 9.52 26.27 30.33 +48 2 6.55 9.25 20.32 +49 2 10.49 1.91 23.31 +50 2 17.63 1.17 14.48 +51 2 1.56 25.17 4.69 +52 2 9.08 10.39 2.29 +53 2 25.92 7.4 21.53 +54 2 25.3 5.14 28.4 +55 2 5.63 23.26 19.85 +56 2 9.6 9.85 24.85 +57 2 3.32 2.77 9.12 +58 2 28.54 15.28 22.18 +59 2 20.45 8.24 18.25 +60 2 12.86 3.73 11.61 +61 2 7.42 12.05 13.54 +62 2 1.73 28.54 25.27 +63 2 3.25 22.18 23.7 +64 2 3.27 25.38 2.24 +65 2 13.46 15.67 19.28 +66 2 31.0 6.91 13.61 +67 2 4.85 27.3 12.67 +68 2 24.48 13.52 4.98 +69 2 23.93 29.62 19.71 +70 2 5.03 13.35 19.5 +71 2 24.58 13.46 19.59 +72 2 7.42 6.82 9.03 +73 2 28.76 15.1 3.33 +74 2 12.38 17.21 6.63 +75 2 15.75 21.23 27.02 +76 2 4.58 5.06 28.19 +77 2 26.04 23.3 25.38 +78 2 30.02 7.27 9.52 +79 2 6.93 10.03 24.54 +80 2 5.61 26.93 27.34 +81 2 29.12 19.12 5.54 +82 2 18.44 27.8 14.75 +83 2 14.1 23.13 9.78 +84 2 24.12 5.55 20.72 +85 2 2.52 10.99 18.44 +86 2 1.76 6.41 21.47 +87 2 25.22 9.56 30.66 +88 2 11.87 13.25 9.12 +89 2 19.46 0.3 22.07 +90 2 28.82 12.29 11.36 +91 2 28.47 30.29 14.09 +92 2 25.51 20.94 24.33 +93 2 1.14 25.4 8.76 +94 2 1.33 27.98 3.09 +95 2 20.57 26.97 -0.04 +96 2 22.73 1.18 0.62 +97 2 19.16 16.99 30.52 +98 2 0.39 9.65 9.02 +99 2 4.41 7.21 3.22 +100 2 11.07 30.64 25.91 +101 1 7.93 25.84 26.26 +102 1 26.76 2.51 2.93 +103 1 30.8 18.15 18.49 +104 1 10.2 7.46 30.44 +105 1 4.77 20.39 26.99 +106 1 25.27 26.77 1.64 +107 1 28.51 13.99 9.33 +108 1 13.86 8.04 24.9 +109 1 30.67 29.88 23.01 +110 1 29.49 30.58 30.02 +111 1 28.74 5.08 30.95 +112 1 13.21 4.31 30.96 +113 1 5.27 3.66 5.02 +114 1 29.43 7.99 17.07 +115 1 4.19 1.37 16.63 +116 1 1.27 27.81 16.56 +117 1 30.64 5.73 25.91 +118 1 10.33 5.33 26.48 +119 1 11.56 21.77 14.77 +120 1 26.46 27.17 5.7 +121 1 14.85 25.79 8.64 +122 1 22.62 6.18 17.61 +123 1 3.45 18.53 11.84 +124 1 11.65 18.17 15.97 +125 1 23.16 17.0 1.5 +126 1 18.92 16.01 3.98 +127 1 30.05 0.25 5.23 +128 1 26.06 11.96 21.96 +129 1 16.82 2.0 10.25 +130 1 19.58 2.63 24.75 +131 1 20.09 14.75 26.62 +132 1 3.14 0.05 26.13 +133 1 4.86 11.79 12.99 +134 1 1.86 11.32 28.57 +135 1 8.82 28.6 6.22 +136 1 20.85 24.68 23.87 +137 1 7.58 25.15 3.44 +138 1 23.46 9.13 8.11 +139 1 6.45 10.24 27.37 +140 1 15.06 10.35 26.71 +141 1 13.8 18.39 26.5 +142 1 5.11 7.7 5.83 +143 1 23.27 23.16 6.67 +144 1 6.33 1.31 11.37 +145 1 14.66 22.28 21.43 +146 1 7.9 8.65 0.61 +147 1 21.83 3.67 26.17 +148 1 1.41 23.66 11.09 +149 1 10.19 17.23 22.71 +150 1 29.53 27.31 23.19 +151 1 28.69 11.38 2.33 +152 1 1.07 2.97 14.53 +153 1 23.47 30.53 14.32 +154 1 1.59 18.83 14.75 +155 1 20.38 30.6 24.38 +156 1 19.81 29.95 27.9 +157 1 12.68 27.59 26.46 +158 1 20.46 9.14 29.06 +159 1 8.69 13.98 24.71 +160 1 0.72 9.29 30.28 +161 1 11.81 20.55 12.28 +162 1 23.8 13.8 9.4 +163 1 13.63 0.51 0.95 +164 1 2.33 6.68 14.95 +165 1 15.98 6.35 25.28 +166 1 7.38 14.88 18.44 +167 1 17.07 20.48 29.16 +168 1 14.53 1.49 8.4 +169 1 28.45 1.21 20.58 +170 1 0.07 5.28 29.45 +171 1 26.0 9.98 15.37 +172 1 14.56 6.91 14.46 +173 1 20.6 9.09 23.04 +174 1 26.02 4.59 0.14 +175 1 5.21 21.9 17.55 +176 1 2.44 7.72 1.47 +177 1 1.25 30.0 13.48 +178 1 27.27 23.13 14.61 +179 1 24.04 15.61 21.64 +180 1 25.13 5.24 17.43 +181 1 4.2 15.98 12.34 +182 1 26.92 13.54 12.87 +183 1 3.38 19.38 9.08 +184 1 27.75 25.03 2.15 +185 1 26.13 20.68 16.54 +186 1 8.3 14.6 13.49 +187 1 3.04 22.87 29.93 +188 1 9.5 26.41 21.23 +189 1 6.53 2.16 2.75 +190 1 6.37 29.04 2.63 +191 1 26.58 4.38 19.69 +192 1 28.44 6.56 14.66 +193 1 25.55 11.1 28.03 +194 1 25.5 18.39 28.73 +195 1 27.67 23.47 5.65 +196 1 13.69 14.81 16.17 +197 1 22.97 27.61 24.11 +198 1 2.06 18.58 30.22 +199 1 2.07 7.13 29.2 +200 1 13.0 7.26 17.76 +201 1 10.04 16.22 30.62 +202 1 6.54 9.8 17.47 +203 1 5.65 12.68 0.64 +204 1 20.84 20.25 23.02 +205 1 22.48 27.63 21.48 +206 1 15.61 22.73 5.36 +207 1 3.52 30.36 6.24 +208 1 6.38 17.25 26.36 +209 1 14.13 10.57 22.63 +210 1 10.22 25.11 3.64 +211 1 16.63 14.7 25.08 +212 1 3.51 29.69 2.76 +213 1 19.2 11.9 21.44 +214 1 30.8 23.85 14.75 +215 1 21.02 14.34 12.4 +216 1 2.75 22.13 27.29 +217 1 29.27 14.29 6.8 +218 1 8.44 20.67 5.23 +219 1 9.42 20.06 22.95 +220 1 30.83 10.64 19.73 +221 1 19.33 14.14 8.94 +222 1 14.18 11.32 18.19 +223 1 26.55 2.39 28.55 +224 1 6.83 16.57 8.9 +225 1 13.98 8.79 1.97 +226 1 4.94 3.0 23.16 +227 1 25.39 29.46 0.63 +228 1 15.32 16.43 2.45 +229 1 5.26 29.73 29.87 +230 1 26.92 14.84 19.93 +231 1 11.87 30.08 4.52 +232 1 7.17 6.71 2.23 +233 1 10.46 1.13 18.11 +234 1 28.59 20.57 25.68 +235 1 26.54 4.84 8.44 +236 1 16.46 18.37 26.15 +237 1 30.53 0.74 15.31 +238 1 27.25 6.31 27.09 +239 1 22.42 1.65 3.87 +240 1 17.85 3.77 8.02 +241 1 11.82 8.23 11.15 +242 1 8.62 27.66 15.87 +243 1 25.19 1.89 18.37 +244 1 14.0 21.96 30.21 +245 1 29.3 1.73 28.29 +246 1 9.35 24.02 12.03 +247 1 1.05 21.5 0.35 +248 1 21.87 20.54 2.54 +249 1 10.59 15.98 17.51 +250 1 22.76 6.0 9.32 +251 1 0.31 9.13 11.87 +252 1 29.16 25.13 18.29 +253 1 1.23 29.08 7.75 +254 1 30.01 28.49 26.21 +255 1 1.87 5.92 5.03 +256 1 1.15 10.27 22.35 +257 1 11.83 10.31 5.16 +258 1 20.89 8.28 8.14 +259 1 13.48 11.78 28.37 +260 1 6.82 10.48 10.25 +261 1 7.34 4.49 18.73 +262 1 5.49 22.37 14.23 +263 1 12.31 21.05 27.47 +264 1 24.09 17.4 8.65 +265 1 22.03 11.54 20.98 +266 1 16.68 13.17 0.68 +267 1 5.52 1.47 8.78 +268 1 14.95 11.83 7.95 +269 1 5.9 10.66 7.12 +270 1 10.06 11.28 30.73 +271 1 17.72 10.71 27.46 +272 1 13.6 6.23 10.82 +273 1 23.42 30.72 9.31 +274 1 23.27 4.25 3.8 +275 1 13.79 8.37 21.07 +276 1 5.01 30.13 12.61 +277 1 26.04 24.45 17.25 +278 1 22.59 14.31 0.81 +279 1 23.74 10.37 17.17 +280 1 23.4 8.52 12.55 +281 1 10.53 23.97 21.96 +282 1 0.69 13.92 28.42 +283 1 6.94 6.27 15.01 +284 1 29.8 20.92 3.41 +285 1 10.19 20.68 19.0 +286 1 26.38 25.4 28.89 +287 1 12.34 26.9 8.27 +288 1 15.0 7.69 6.4 +289 1 24.75 13.1 2.24 +290 1 4.5 20.58 6.78 +291 1 23.27 18.25 11.48 +292 1 25.92 26.39 22.66 +293 1 24.63 4.21 6.52 +294 1 16.68 15.05 15.6 +295 1 26.39 16.17 29.89 +296 1 10.12 6.21 8.63 +297 1 14.41 14.67 12.23 +298 1 19.59 3.47 1.47 +299 1 28.21 22.43 18.25 +300 1 27.87 29.74 11.47 +301 1 22.53 24.1 13.94 +302 1 12.55 1.58 29.82 +303 1 17.45 21.28 8.34 +304 1 16.3 10.75 16.22 +305 1 16.34 13.25 17.65 +306 1 8.44 4.52 0.93 +307 1 17.47 23.79 2.3 +308 1 29.04 26.8 5.13 +309 1 13.13 11.34 24.9 +310 1 24.33 13.0 13.32 +311 1 8.21 29.74 24.23 +312 1 21.79 28.0 5.85 +313 1 13.74 20.08 10.26 +314 1 20.92 24.38 6.01 +315 1 9.83 29.56 17.99 +316 1 26.66 30.76 2.95 +317 1 24.34 3.08 1.67 +318 1 28.09 10.69 23.33 +319 1 7.08 25.28 0.77 +320 1 15.34 1.12 29.82 +321 1 26.07 12.55 7.74 +322 1 16.85 0.81 21.24 +323 1 9.96 0.57 6.36 +324 1 29.4 2.54 1.18 +325 1 5.81 1.0 5.42 +326 1 25.16 24.89 11.15 +327 1 15.43 24.93 13.71 +328 1 24.6 10.06 10.58 +329 1 20.4 12.04 15.51 +330 1 15.72 18.9 0.21 +331 1 16.5 17.21 28.81 +332 1 16.79 3.11 12.74 +333 1 22.75 6.22 6.6 +334 1 8.09 19.86 30.92 +335 1 24.15 8.75 23.65 +336 1 12.24 30.51 15.39 +337 1 8.15 26.8 18.69 +338 1 0.1 15.0 15.49 +339 1 29.84 15.71 30.0 +340 1 15.39 18.25 11.17 +341 1 1.2 15.49 18.8 +342 1 27.55 9.81 17.9 +343 1 18.93 8.9 10.06 +344 1 28.35 12.36 4.82 +345 1 11.21 13.71 30.62 +346 1 2.5 16.67 16.33 +347 1 0.47 4.2 6.99 +348 1 23.72 4.38 12.28 +349 1 16.59 3.54 16.9 +350 1 17.31 17.81 15.8 +351 1 11.58 0.3 21.21 +352 1 23.67 21.91 15.84 +353 1 7.74 2.78 23.52 +354 1 14.34 9.65 4.52 +355 1 23.35 10.88 14.55 +356 1 3.51 10.03 20.99 +357 1 14.63 21.34 1.75 +358 1 24.37 8.39 2.96 +359 1 14.8 15.5 30.48 +360 1 2.59 1.32 12.76 +361 1 0.16 13.81 25.49 +362 1 11.26 10.11 27.84 +363 1 27.8 18.65 15.07 +364 1 5.07 5.43 21.33 +365 1 14.06 5.26 19.67 +366 1 3.76 18.23 19.36 +367 1 26.68 27.25 10.67 +368 1 7.72 19.58 13.64 +369 1 29.48 16.94 16.45 +370 1 28.18 13.38 30.28 +371 1 29.97 10.41 16.17 +372 1 11.97 28.73 29.31 +373 1 14.88 0.79 25.43 +374 1 8.98 23.85 7.66 +375 1 4.78 8.21 9.79 +376 1 21.74 20.61 28.64 +377 1 20.36 18.75 17.92 +378 1 12.61 21.65 23.18 +379 1 6.36 29.76 8.49 +380 1 12.51 26.69 18.69 +381 1 22.2 17.41 6.86 +382 1 11.7 6.53 21.66 +383 1 4.62 16.22 3.24 +384 1 0.76 13.73 0.83 +385 1 21.91 13.43 5.67 +386 1 17.36 6.16 4.12 +387 1 0.34 28.1 11.89 +388 1 2.43 26.92 20.47 +389 1 0.99 22.41 4.14 +390 1 23.77 24.66 24.16 +391 1 22.41 7.79 20.57 +392 1 16.4 22.82 23.46 +393 1 24.68 28.28 17.44 +394 1 14.99 26.21 27.12 +395 1 0.75 13.41 7.7 +396 1 16.43 5.69 21.09 +397 1 19.5 6.71 27.89 +398 1 14.32 17.4 22.9 +399 1 29.04 27.81 19.17 +400 1 9.52 19.68 10.69 +401 1 5.33 27.17 17.3 +402 1 5.2 12.64 9.11 +403 1 9.8 6.14 19.74 +404 1 9.86 22.71 1.2 +405 1 0.84 12.31 14.9 +406 1 18.79 12.07 17.76 +407 1 27.21 25.79 14.27 +408 1 6.11 1.01 19.83 +409 1 8.44 5.68 12.85 +410 1 22.42 26.4 1.81 +411 1 24.0 20.11 18.63 +412 1 2.32 26.11 12.18 +413 1 26.06 7.28 15.77 +414 1 9.96 9.13 19.49 +415 1 10.74 12.01 25.79 +416 1 30.39 1.07 11.77 +417 1 9.49 20.19 26.63 +418 1 15.99 30.59 6.78 +419 1 11.0 30.74 0.96 +420 1 23.67 30.14 22.75 +421 1 24.14 9.9 19.82 +422 1 5.88 5.5 7.25 +423 1 3.45 10.72 9.52 +424 1 11.78 25.26 29.31 +425 1 15.95 27.28 17.71 +426 1 17.99 16.5 8.95 +427 1 28.47 0.47 23.29 +428 1 14.06 1.39 12.17 +429 1 19.28 23.85 8.27 +430 1 13.62 4.42 14.21 +431 1 2.98 9.89 12.04 +432 1 7.35 14.53 10.79 +433 1 15.55 0.87 3.17 +434 1 7.7 24.24 23.88 +435 1 17.61 8.64 6.93 +436 1 5.17 26.9 3.74 +437 1 1.06 17.17 27.8 +438 1 18.8 9.64 19.81 +439 1 8.36 1.64 0.63 +440 1 13.68 14.97 7.75 +441 1 29.56 0.55 17.98 +442 1 3.01 24.45 14.3 +443 1 11.98 7.48 26.92 +444 1 19.13 24.44 27.57 +445 1 11.75 14.57 11.88 +446 1 13.1 4.54 22.64 +447 1 7.2 21.26 28.21 +448 1 24.85 22.96 28.77 +449 1 15.0 23.95 16.32 +450 1 24.6 14.43 15.56 +451 1 3.05 13.66 17.69 +452 1 3.0 3.39 6.37 +453 1 24.92 22.04 13.42 +454 1 21.24 2.56 17.68 +455 1 19.69 0.3 11.75 +456 1 5.73 29.89 26.41 +457 1 7.62 30.1 0.37 +458 1 14.62 28.23 20.86 +459 1 8.72 5.14 23.94 +460 1 9.94 25.78 9.45 +461 1 17.3 4.53 0.74 +462 1 17.58 12.58 14.58 +463 1 8.64 2.55 20.15 +464 1 21.07 10.96 26.32 +465 1 27.85 4.23 10.9 +466 1 20.41 29.07 20.84 +467 1 9.35 12.65 10.7 +468 1 9.88 0.73 3.41 +469 1 26.64 20.78 1.33 +470 1 25.47 19.72 10.96 +471 1 1.01 5.01 12.19 +472 1 10.11 27.98 23.8 +473 1 17.51 0.24 28.51 +474 1 21.85 14.89 8.07 +475 1 18.22 12.88 29.4 +476 1 10.97 16.02 2.55 +477 1 4.3 25.33 5.86 +478 1 12.67 27.62 3.28 +479 1 12.18 24.26 16.74 +480 1 0.24 29.32 20.41 +481 1 5.03 15.5 6.14 +482 1 11.11 12.43 6.7 +483 1 10.14 4.47 15.0 +484 1 2.9 6.91 24.11 +485 1 30.6 4.29 16.4 +486 1 9.61 4.66 29.44 +487 1 5.38 17.6 1.1 +488 1 3.71 5.22 11.92 +489 1 8.93 11.33 8.19 +490 1 31.02 28.82 0.48 +491 1 0.81 2.74 23.14 +492 1 16.45 28.36 8.16 +493 1 2.1 8.36 17.2 +494 1 25.82 16.89 1.44 +495 1 20.21 11.2 11.56 +496 1 13.88 23.42 27.01 +497 1 30.15 5.56 2.54 +498 1 1.76 17.51 24.41 +499 1 18.18 8.62 16.29 +500 1 4.41 20.18 15.26 +501 1 7.05 29.39 19.64 +502 1 22.92 21.56 26.41 +503 1 29.43 3.25 12.91 +504 1 16.92 25.1 29.07 +505 1 25.4 12.48 17.22 +506 1 7.4 5.74 28.39 +507 1 0.14 3.32 27.06 +508 1 29.61 24.31 3.76 +509 1 13.25 25.77 23.43 +510 1 19.18 28.02 24.33 +511 1 3.66 10.37 26.9 +512 1 12.53 11.26 1.28 +513 1 28.21 7.27 11.49 +514 1 26.9 9.35 3.39 +515 1 18.87 28.09 9.36 +516 1 9.3 30.5 15.62 +517 1 12.34 13.23 3.13 +518 1 27.93 26.52 26.46 +519 1 7.78 9.29 14.0 +520 1 16.12 6.82 1.73 +521 1 0.63 2.82 20.33 +522 1 12.2 26.56 13.2 +523 1 6.16 16.1 15.43 +524 1 13.49 24.29 6.85 +525 1 28.61 10.73 30.64 +526 1 19.98 17.97 5.68 +527 1 2.75 19.83 4.73 +528 1 18.41 26.18 2.29 +529 1 22.35 24.43 11.05 +530 1 4.45 4.92 15.13 +531 1 16.8 18.43 21.99 +532 1 2.08 4.57 24.87 +533 1 26.03 2.02 24.82 +534 1 15.65 30.12 19.2 +535 1 27.88 13.79 27.66 +536 1 29.03 7.86 2.9 +537 1 2.68 5.55 9.4 +538 1 30.45 11.98 23.35 +539 1 2.08 19.71 21.15 +540 1 11.06 3.11 4.38 +541 1 21.61 14.28 20.83 +542 1 15.85 5.82 12.29 +543 1 29.7 22.61 8.47 +544 1 29.5 7.81 27.38 +545 1 24.12 20.22 0.4 +546 1 16.0 25.22 21.34 +547 1 19.8 25.24 13.43 +548 1 7.11 16.71 4.39 +549 1 4.59 0.13 21.8 +550 1 20.94 12.01 28.92 +551 1 12.99 2.09 6.04 +552 1 19.45 19.38 14.86 +553 1 12.98 23.9 12.88 +554 1 13.06 12.04 20.67 +555 1 17.56 1.18 25.76 +556 1 29.88 16.58 1.42 +557 1 6.04 13.87 25.34 +558 1 25.5 6.08 10.63 +559 1 20.34 11.15 2.51 +560 1 3.82 11.92 15.57 +561 1 10.47 18.64 8.01 +562 1 13.02 24.92 20.67 +563 1 20.03 29.78 7.22 +564 1 8.36 11.63 28.63 +565 1 14.06 21.56 15.74 +566 1 9.4 28.78 29.81 +567 1 9.07 10.18 22.15 +568 1 11.47 22.66 29.81 +569 1 17.02 8.02 27.19 +570 1 29.56 18.32 21.38 +571 1 8.58 8.58 11.23 +572 1 22.15 19.86 15.25 +573 1 12.34 29.83 7.16 +574 1 20.52 25.35 20.66 +575 1 21.23 5.6 23.05 +576 1 23.45 10.69 5.93 +577 1 14.15 4.81 4.29 +578 1 8.26 24.58 28.88 +579 1 10.03 3.4 7.88 +580 1 25.65 7.23 0.84 +581 1 7.28 26.7 9.09 +582 1 20.47 29.31 16.02 +583 1 4.44 7.7 27.1 +584 1 27.95 23.13 0.39 +585 1 19.82 18.98 12.12 +586 1 20.01 5.07 14.72 +587 1 1.66 1.23 5.19 +588 1 5.6 11.21 22.59 +589 1 3.81 22.68 4.63 +590 1 17.47 14.06 22.25 +591 1 16.77 22.61 10.71 +592 1 7.2 26.5 22.52 +593 1 10.75 17.97 28.76 +594 1 16.61 8.28 20.88 +595 1 0.81 27.72 28.37 +596 1 6.78 22.71 4.37 +597 1 27.35 28.79 17.13 +598 1 15.16 3.34 2.07 +599 1 19.69 29.89 30.66 +600 1 17.34 20.23 2.18 +601 1 15.65 15.76 9.8 +602 1 19.07 19.02 8.23 +603 1 26.13 0.42 7.37 +604 1 4.29 9.29 15.94 +605 1 7.86 7.42 4.84 +606 1 23.4 1.93 16.16 +607 1 5.27 27.16 0.17 +608 1 27.08 14.52 1.58 +609 1 8.34 11.25 18.53 +610 1 10.4 17.83 12.7 +611 1 8.86 18.1 18.73 +612 1 17.69 22.57 26.0 +613 1 6.1 6.61 11.68 +614 1 24.32 13.38 23.99 +615 1 0.13 20.78 22.53 +616 1 10.96 20.82 6.33 +617 1 28.46 1.62 7.03 +618 1 16.9 4.13 23.44 +619 1 1.89 11.75 5.82 +620 1 3.27 20.91 2.26 +621 1 11.14 15.5 24.78 +622 1 21.76 3.5 20.99 +623 1 3.95 12.22 24.49 +624 1 7.26 23.31 16.11 +625 1 19.28 20.97 21.06 +626 1 7.2 17.22 22.12 +627 1 16.26 10.81 24.17 +628 1 1.54 24.72 17.86 +629 1 17.74 0.11 1.5 +630 1 25.85 5.87 23.82 +631 1 4.21 7.73 13.47 +632 1 20.87 8.0 25.94 +633 1 22.23 3.22 8.98 +634 1 13.72 30.72 23.05 +635 1 4.91 26.26 19.85 +636 1 14.82 27.52 13.76 +637 1 27.5 3.72 26.36 +638 1 27.62 9.82 10.27 +639 1 19.32 8.78 3.53 +640 1 16.33 28.86 1.39 +641 1 30.26 10.13 4.93 +642 1 14.94 29.37 4.67 +643 1 7.61 12.27 21.0 +644 1 5.31 18.92 23.16 +645 1 25.19 3.1 14.51 +646 1 8.12 21.6 9.56 +647 1 20.35 17.71 23.89 +648 1 3.39 19.78 24.7 +649 1 5.42 23.52 1.93 +650 1 29.44 5.52 23.47 +651 1 23.83 22.25 20.16 +652 1 17.93 4.41 19.13 +653 1 9.44 1.91 29.19 +654 1 29.91 23.65 12.09 +655 1 27.06 21.35 3.96 +656 1 16.28 19.92 14.78 +657 1 19.99 5.38 17.54 +658 1 14.54 21.16 7.89 +659 1 26.09 14.97 10.68 +660 1 0.63 24.05 28.89 +661 1 5.07 25.73 10.62 +662 1 6.78 8.27 29.12 +663 1 11.86 12.77 15.67 +664 1 21.83 14.26 24.49 +665 1 23.7 1.53 6.32 +666 1 28.91 27.7 13.19 +667 1 16.46 28.92 23.22 +668 1 26.22 15.29 23.65 +669 1 23.75 1.5 21.21 +670 1 4.08 23.38 11.4 +671 1 29.4 29.73 2.7 +672 1 8.94 16.2 27.64 +673 1 30.79 23.65 6.33 +674 1 27.04 17.6 10.45 +675 1 21.48 15.71 29.11 +676 1 17.68 22.29 18.33 +677 1 22.1 29.54 1.71 +678 1 16.17 27.33 3.65 +679 1 9.22 5.24 5.71 +680 1 1.81 4.91 1.83 +681 1 30.98 28.61 5.42 +682 1 0.24 6.26 18.55 +683 1 17.39 24.85 11.97 +684 1 28.21 20.4 22.88 +685 1 23.01 8.35 29.39 +686 1 4.03 15.76 25.76 +687 1 3.89 12.75 4.32 +688 1 16.42 9.73 9.22 +689 1 14.74 17.01 13.68 +690 1 11.65 22.66 10.77 +691 1 21.04 26.56 25.76 +692 1 3.97 29.83 10.01 +693 1 10.62 26.12 25.57 +694 1 17.97 8.53 23.31 +695 1 19.22 16.46 13.24 +696 1 2.39 24.13 25.42 +697 1 1.72 21.99 14.71 +698 1 14.16 25.55 4.52 +699 1 10.58 12.26 13.38 +700 1 25.76 29.55 5.46 +701 1 24.18 1.25 26.8 +702 1 30.61 26.16 30.37 +703 1 3.38 16.05 28.52 +704 1 1.18 24.43 20.96 +705 1 7.9 1.26 25.66 +706 1 26.57 10.39 5.82 +707 1 8.44 8.09 16.34 +708 1 16.67 27.55 25.72 +709 1 7.45 2.82 7.35 +710 1 19.18 19.09 28.22 +711 1 12.68 8.88 30.58 +712 1 27.98 26.24 30.75 +713 1 11.84 28.3 20.75 +714 1 10.45 30.97 11.14 +715 1 8.96 2.33 11.92 +716 1 7.66 10.26 5.22 +717 1 23.5 12.98 28.85 +718 1 30.48 8.08 21.02 +719 1 16.48 29.96 10.33 +720 1 13.88 5.72 8.08 +721 1 27.47 28.22 21.47 +722 1 26.74 18.07 22.5 +723 1 25.13 23.78 0.9 +724 1 29.21 15.71 26.07 +725 1 19.41 3.92 10.58 +726 1 24.96 7.64 5.7 +727 1 7.44 14.1 29.85 +728 1 7.13 12.21 3.18 +729 1 16.35 14.7 4.18 +730 1 1.43 15.6 11.58 +731 1 30.27 1.93 9.17 +732 1 2.77 2.54 27.69 +733 1 11.36 27.83 16.39 +734 1 7.83 2.36 14.66 +735 1 19.3 12.28 5.63 +736 1 28.36 12.19 19.25 +737 1 10.67 7.34 13.62 +738 1 26.6 24.47 21.0 +739 1 8.55 29.42 27.3 +740 1 25.79 25.13 4.07 +741 1 28.21 8.09 22.88 +742 1 22.44 11.07 23.78 +743 1 27.76 17.89 25.74 +744 1 2.23 0.19 23.48 +745 1 10.49 12.99 20.29 +746 1 18.74 11.84 24.74 +747 1 29.46 2.69 24.54 +748 1 3.11 29.29 15.2 +749 1 21.8 19.07 20.45 +750 1 11.21 17.26 20.08 +751 1 2.59 26.55 26.79 +752 1 23.67 25.82 17.79 +753 1 23.43 27.91 15.08 +754 1 6.86 2.11 28.13 +755 1 14.38 19.97 19.61 +756 1 29.05 26.41 8.62 +757 1 3.34 9.63 6.81 +758 1 21.41 30.88 18.45 +759 1 30.35 16.75 23.77 +760 1 19.92 6.73 20.92 +761 1 26.4 1.5 11.47 +762 1 16.6 8.88 30.96 +763 1 23.25 29.76 4.34 +764 1 17.15 13.45 7.34 +765 1 14.52 14.34 23.37 +766 1 11.77 3.31 25.06 +767 1 15.52 25.25 0.94 +768 1 21.53 27.39 12.97 +769 1 11.29 10.11 17.38 +770 1 11.07 15.06 5.47 +771 1 27.61 7.39 6.07 +772 1 15.82 4.83 27.63 +773 1 17.16 20.28 12.25 +774 1 3.18 28.03 22.92 +775 1 25.53 27.61 25.22 +776 1 1.81 16.55 1.25 +777 1 3.72 16.82 7.97 +778 1 7.68 21.57 2.11 +779 1 21.85 26.93 28.36 +780 1 10.31 8.57 4.0 +781 1 11.61 9.88 14.35 +782 1 0.41 8.48 24.13 +783 1 3.8 10.63 30.74 +784 1 2.74 17.0 21.82 +785 1 28.44 22.73 28.74 +786 1 2.08 0.43 20.23 +787 1 0.25 9.36 2.02 +788 1 27.68 11.33 26.53 +789 1 27.63 4.1 14.74 +790 1 19.68 0.89 3.22 +791 1 17.12 30.74 17.17 +792 1 16.11 25.62 24.01 +793 1 20.49 9.58 13.85 +794 1 26.77 20.78 27.64 +795 1 18.77 16.87 25.93 +796 1 7.01 13.49 6.76 +797 1 18.38 16.84 18.4 +798 1 8.54 14.44 4.51 +799 1 11.51 1.42 8.98 +800 1 17.06 14.93 12.29 +801 1 6.07 0.24 15.08 +802 1 8.76 17.53 2.01 +803 1 19.63 6.58 1.71 +804 1 10.24 4.66 10.93 +805 1 4.39 20.15 30.88 +806 1 30.31 16.7 6.24 +807 1 26.0 30.16 27.34 +808 1 6.44 21.42 21.88 +809 1 22.05 29.62 11.43 +810 1 21.94 22.11 9.22 +811 1 21.82 1.59 13.13 +812 1 27.09 0.55 16.64 +813 1 8.88 3.09 17.06 +814 1 6.95 18.85 6.3 +815 1 20.13 2.53 15.07 +816 1 17.52 12.36 3.26 +817 1 18.46 7.24 13.99 +818 1 12.61 6.94 3.36 +819 1 15.55 17.46 19.11 +820 1 16.13 27.37 11.33 +821 1 2.99 14.41 9.34 +822 1 5.81 22.26 24.67 +823 1 19.82 2.53 6.19 +824 1 28.93 5.65 7.69 +825 1 17.89 22.05 15.68 +826 1 5.63 7.81 23.81 +827 1 19.09 16.3 22.05 +828 1 1.07 19.82 27.06 +829 1 14.74 8.15 28.71 +830 1 16.98 10.27 4.92 +831 1 13.39 20.01 5.47 +832 1 21.23 3.56 30.15 +833 1 29.23 18.12 28.24 +834 1 16.76 24.31 7.29 +835 1 26.12 21.8 21.5 +836 1 0.2 13.1 12.25 +837 1 1.99 3.78 30.39 +838 1 26.67 20.02 19.27 +839 1 20.63 10.01 5.91 +840 1 4.44 3.74 1.84 +841 1 21.95 6.78 0.24 +842 1 9.86 22.51 17.05 +843 1 26.17 7.64 18.91 +844 1 17.09 20.11 19.78 +845 1 10.38 9.07 9.16 +846 1 9.92 13.21 17.39 +847 1 24.26 19.17 3.05 +848 1 13.32 18.96 29.06 +849 1 27.98 20.32 7.7 +850 1 10.35 6.44 17.04 +851 1 27.27 28.95 29.77 +852 1 7.71 19.32 24.95 +853 1 23.11 17.51 14.39 +854 1 25.37 14.39 26.26 +855 1 4.73 3.99 17.92 +856 1 28.53 17.74 8.3 +857 1 28.99 9.49 7.65 +858 1 11.37 3.77 18.66 +859 1 11.01 23.57 6.0 +860 1 7.29 17.47 30.27 +861 1 18.92 10.24 0.36 +862 1 22.76 24.44 27.3 +863 1 14.27 13.05 5.04 +864 1 3.42 14.59 30.9 +865 1 9.31 22.34 24.75 +866 1 25.78 16.96 15.63 +867 1 7.18 22.01 12.25 +868 1 5.0 18.29 28.57 +869 1 23.36 20.87 22.7 +870 1 13.16 10.8 10.17 +871 1 6.42 24.78 7.47 +872 1 28.86 3.89 20.92 +873 1 4.8 3.05 13.07 +874 1 27.07 3.53 5.63 +875 1 13.11 28.33 23.92 +876 1 14.84 13.88 20.8 +877 1 15.81 7.0 16.91 +878 1 23.41 25.39 20.56 +879 1 26.08 0.43 14.19 +880 1 6.28 17.41 19.28 +881 1 2.74 4.79 19.54 +882 1 20.98 26.42 10.11 +883 1 24.18 28.48 29.18 +884 1 12.74 29.99 12.8 +885 1 27.22 16.82 18.13 +886 1 2.08 19.98 18.27 +887 1 22.0 23.67 17.16 +888 1 17.83 3.01 29.13 +889 1 9.59 26.62 13.51 +890 1 11.48 2.18 13.45 +891 1 13.57 15.29 26.47 +892 1 1.72 0.72 9.92 +893 1 2.14 30.76 17.27 +894 1 17.9 15.88 1.47 +895 1 13.47 5.84 28.76 +896 1 8.96 22.14 21.0 +897 1 12.96 24.15 0.94 +898 1 26.13 23.25 8.89 +899 1 6.01 28.65 6.08 +900 1 22.88 20.21 6.1 +901 1 30.34 20.77 10.49 +902 1 12.19 28.16 10.6 +903 1 5.8 5.33 30.84 +904 1 29.83 26.29 15.91 +905 1 18.28 0.14 5.58 +906 1 1.91 17.34 5.88 +907 1 24.05 18.42 22.53 +908 1 10.82 21.55 3.57 +909 1 11.29 26.73 5.6 +910 1 21.34 14.41 3.22 +911 1 12.61 18.99 24.17 +912 1 25.02 18.6 25.9 +913 1 29.0 21.05 13.14 +914 1 17.72 27.28 30.27 +915 1 30.56 24.81 23.12 +916 1 17.09 20.05 24.02 +917 1 7.35 6.83 21.31 +918 1 3.39 22.32 21.05 +919 1 2.28 29.8 30.23 +920 1 5.29 25.66 14.8 +921 1 26.16 30.72 21.04 +922 1 21.63 6.32 11.68 +923 1 15.45 18.06 4.65 +924 1 5.76 28.33 24.04 +925 1 15.08 29.21 16.09 +926 1 18.76 6.14 6.94 +927 1 22.31 30.25 26.46 +928 1 18.49 22.04 30.93 +929 1 11.15 16.42 9.89 +930 1 4.34 7.98 30.25 +931 1 9.29 29.92 8.58 +932 1 22.97 27.09 8.04 +933 1 20.71 16.7 15.75 +934 1 30.36 7.49 5.24 +935 1 29.56 19.54 0.83 +936 1 30.71 14.04 20.91 +937 1 19.36 4.06 27.14 +938 1 23.41 10.8 2.14 +939 1 1.51 1.32 0.44 +940 1 8.16 14.39 1.63 +941 1 20.66 6.74 4.62 +942 1 20.78 26.26 3.85 +943 1 5.11 15.12 21.64 +944 1 12.53 20.03 17.67 +945 1 28.63 18.4 12.56 +946 1 1.95 21.69 8.08 +947 1 21.53 0.93 7.84 +948 1 2.69 22.51 17.17 +949 1 19.29 22.12 6.05 +950 1 23.68 2.14 11.01 +951 1 27.14 17.8 3.72 +952 1 2.22 14.81 3.31 +953 1 23.1 6.43 14.62 +954 1 0.22 12.59 3.57 +955 1 13.21 22.86 3.67 +956 1 13.45 2.1 20.14 +957 1 12.52 17.12 0.46 +958 1 3.07 27.45 9.03 +959 1 15.33 10.95 11.78 +960 1 0.05 4.26 9.75 +961 1 23.05 16.98 24.69 +962 1 16.15 16.28 6.51 +963 1 30.05 28.87 9.61 +964 1 6.67 29.5 16.95 +965 1 21.95 14.44 14.94 +966 1 22.58 22.47 30.33 +967 1 21.34 19.29 9.9 +968 1 29.31 21.79 20.79 +969 1 5.55 2.56 30.23 +970 1 25.88 3.17 22.22 +971 1 22.38 18.32 30.08 +972 1 6.27 19.24 8.86 +973 1 0.34 24.29 1.49 +974 1 20.49 24.13 0.25 +975 1 2.94 1.41 2.74 +976 1 24.88 25.38 7.35 +977 1 28.18 14.89 14.6 +978 1 7.84 30.36 4.39 +979 1 14.54 9.59 14.4 +980 1 27.63 12.3 15.83 +981 1 11.15 14.17 27.97 +982 1 25.27 20.88 8.35 +983 1 17.06 14.76 27.78 +984 1 3.9 14.79 15.06 +985 1 13.81 3.82 17.03 +986 1 28.55 24.1 26.15 +987 1 29.28 21.79 15.76 +988 1 15.05 30.12 27.83 +989 1 15.42 3.77 6.76 +990 1 22.65 12.12 11.24 +991 1 11.29 4.96 2.18 +992 1 2.15 7.43 7.57 +993 1 30.21 10.13 26.21 +994 1 24.42 22.18 4.42 +995 1 8.68 14.72 22.08 +996 1 23.1 6.9 27.1 +997 1 18.71 27.2 21.72 +998 1 14.12 12.7 30.76 +999 1 18.81 6.5 10.98 +1000 1 26.66 15.4 4.83 diff --git a/examples/PACKAGES/pair_3b_table/spce_2.in b/examples/PACKAGES/pair_3b_table/spce_2.in new file mode 100644 index 0000000000..55db11b7cb --- /dev/null +++ b/examples/PACKAGES/pair_3b_table/spce_2.in @@ -0,0 +1,43 @@ +log none + +units real +atom_style atomic + +read_data spce_2.data + +#hybrid pair style consisting of +#pair_style table to read in CG pair potential +#pair_style 3b/table for tabulated 3b interactions +pair_style hybrid/overlay table linear 1200 3b/table + +#pair coefficients +pair_coeff * * table table_CG_CG.txt VOTCA +pair_coeff * * 3b/table spce_2.3b type1 type2 + +#nvt run with nose-hoover thermostat +#time coupling of 100 ts for thermostat +#target T is 300 K +fix 1 all nvt temp 300.0 300.0 200.0 + +#create initial velocities +velocity all create 300 432567 dist uniform +#remove center of mass linear momentum +velocity all zero linear + +#remove center of mass linear momentum every 1000 time steps in each cartesian direction +fix remove all momentum 1000 linear 1 1 1 + +#timestep of 2 fs +timestep 2.0 + +#print out thermodynamic info every 100 ts +thermo 100 + +#run 10000 ts +run 10000 + +#write out dump file every 10 ts for 100000 ts +dump 2 all custom 10 spce_2.dump id type x y z fx fy fz +run 100000 + +undump 2 diff --git a/examples/PACKAGES/pair_3b_table/table_CG_CG.txt b/examples/PACKAGES/pair_3b_table/table_CG_CG.txt new file mode 100644 index 0000000000..f4ccdd4b4e --- /dev/null +++ b/examples/PACKAGES/pair_3b_table/table_CG_CG.txt @@ -0,0 +1,1203 @@ +VOTCA +N 1200 R 0.010000 12.000000 + +1 1.0000000000e-02 1.5390100510e+15 2.1517330910e+16 +2 2.0000000000e-02 1.3370836560e+15 1.8774943350e+16 +3 3.0000000000e-02 1.1616510900e+15 1.6231560530e+16 +4 4.0000000000e-02 1.0092362200e+15 1.4101892510e+16 +5 5.0000000000e-02 8.7681900090e+14 1.2251648380e+16 +6 6.0000000000e-02 7.6177563290e+14 1.0644166230e+16 +7 7.0000000000e-02 6.6182657340e+14 9.2475943770e+15 +8 8.0000000000e-02 5.7499136800e+14 8.0342602660e+15 +9 9.0000000000e-02 4.9954940840e+14 6.9801221150e+15 +10 1.0000000000e-01 4.3400583970e+14 6.0642925570e+15 +11 1.1000000000e-01 3.7706193970e+14 5.2686247630e+15 +12 1.2000000000e-01 3.2758938550e+14 4.5773528620e+15 +13 1.3000000000e-01 2.8460789650e+14 3.9767795520e+15 +14 1.4000000000e-01 2.4726581000e+14 3.4550046890e+15 +15 1.5000000000e-01 2.1482320610e+14 3.0016894950e+15 +16 1.6000000000e-01 1.8663724620e+14 2.6078516910e+15 +17 1.7000000000e-01 1.6214943590e+14 2.2656875260e+15 +18 1.8000000000e-01 1.4087455790e+14 1.9684171380e+15 +19 1.9000000000e-01 1.2239105840e+14 1.7101502250e+15 +20 2.0000000000e-01 1.0633269330e+14 1.4857693190e+15 +21 2.1000000000e-01 9.2381272170e+13 1.2908283940e+15 +22 2.2000000000e-01 8.0260352480e+13 1.1214647680e+15 +23 2.3000000000e-01 6.9729762630e+13 9.7432255940e+14 +24 2.4000000000e-01 6.0580842800e+13 8.4648620020e+14 +25 2.5000000000e-01 5.2632310450e+13 7.3542265870e+14 +26 2.6000000000e-01 4.5726668290e+13 6.3893125110e+14 +27 2.7000000000e-01 3.9727083510e+13 5.5510003510e+14 +28 2.8000000000e-01 3.4514676520e+13 4.8226792540e+14 +29 2.9000000000e-01 2.9986165360e+13 4.1899178020e+14 +30 3.0000000000e-01 2.6051819210e+13 3.6401780550e+14 +31 3.1000000000e-01 2.2633680440e+13 3.1625671190e+14 +32 3.2000000000e-01 1.9664019850e+13 2.7476213060e+14 +33 3.3000000000e-01 1.7083994700e+13 2.3871186160e+14 +34 3.4000000000e-01 1.4842482730e+13 2.0739158160e+14 +35 3.5000000000e-01 1.2895069180e+13 1.8018069090e+14 +36 3.6000000000e-01 1.1203166760e+13 1.5654001530e+14 +37 3.7000000000e-01 9.7332510350e+12 1.3600112350e+14 +38 3.8000000000e-01 8.4561961580e+12 1.1815704470e+14 +39 3.9000000000e-01 7.3466977490e+12 1.0265420510e+14 +40 4.0000000000e-01 6.3827714970e+12 8.9185421350e+13 +41 4.1000000000e-01 5.5453175530e+12 7.7483814470e+13 +42 4.2000000000e-01 4.8177420700e+12 6.7317521340e+13 +43 4.3000000000e-01 4.1856284030e+12 5.8485100540e+13 +44 4.4000000000e-01 3.6364514480e+12 5.0811540850e+13 +45 4.5000000000e-01 3.1593294630e+12 4.4144793450e+13 +46 4.6000000000e-01 2.7448084480e+12 3.8352759160e+13 +47 4.7000000000e-01 2.3846748190e+12 3.3320670910e+13 +48 4.8000000000e-01 2.0717926600e+12 2.8948819710e+13 +49 4.9000000000e-01 1.7999623210e+12 2.5150578890e+13 +50 5.0000000000e-01 1.5637975860e+12 2.1850687690e+13 +51 5.1000000000e-01 1.3586189330e+12 1.8983759960e+13 +52 5.2000000000e-01 1.1803608230e+12 1.6492988570e+13 +53 5.3000000000e-01 1.0254911360e+12 1.4329019780e+13 +54 5.4000000000e-01 8.9094118400e+11 1.2448975330e+13 +55 5.5000000000e-01 7.7404490960e+11 1.0815602820e+13 +56 5.6000000000e-01 6.7248605500e+11 9.3965375690e+12 +57 5.7000000000e-01 5.8425226830e+11 8.1636613100e+12 +58 5.8000000000e-01 5.0759522880e+11 7.0925450460e+12 +59 5.9000000000e-01 4.4099600520e+11 6.1619649960e+12 +60 6.0000000000e-01 3.8313495790e+11 5.3534820520e+12 +61 6.1000000000e-01 3.3286559110e+11 4.6510764180e+12 +62 6.2000000000e-01 2.8919183550e+11 4.0408301810e+12 +63 6.3000000000e-01 2.5124831160e+11 3.5106515320e+12 +64 6.4000000000e-01 2.1828318200e+11 3.0500351720e+12 +65 6.5000000000e-01 1.8964325470e+11 2.6498541560e+12 +66 6.6000000000e-01 1.6476103990e+11 2.3021790410e+12 +67 6.7000000000e-01 1.4314350540e+11 2.0001207710e+12 +68 6.8000000000e-01 1.2436230780e+11 1.7376941700e+12 +69 6.9000000000e-01 1.0804530420e+11 1.5096993500e+12 +70 7.0000000000e-01 9.3869179290e+10 1.3116186770e+12 +71 7.1000000000e-01 8.1553038190e+10 1.1395272530e+12 +72 7.2000000000e-01 7.0852841020e+10 9.9001514990e+11 +73 7.3000000000e-01 6.1556567270e+10 8.6011983840e+11 +74 7.4000000000e-01 5.3480014620e+10 7.4726749030e+11 +75 7.5000000000e-01 4.6463149110e+10 6.4922197710e+11 +76 7.6000000000e-01 4.0366934090e+10 5.6404056250e+11 +77 7.7000000000e-01 3.5070575270e+10 4.9003540760e+11 +78 7.8000000000e-01 3.0469127200e+10 4.2574012690e+11 +79 7.9000000000e-01 2.6471413860e+10 3.6988073290e+11 +80 8.0000000000e-01 2.2998222010e+10 3.2135039170e+11 +81 8.1000000000e-01 1.9980731610e+10 2.7918749220e+11 +82 8.2000000000e-01 1.7359152180e+10 2.4255659190e+11 +83 8.3000000000e-01 1.5081538060e+10 2.1073186270e+11 +84 8.4000000000e-01 1.3102759170e+10 1.8308270910e+11 +85 8.5000000000e-01 1.1383606700e+10 1.5906127310e+11 +86 8.6000000000e-01 9.8900162880e+09 1.3819157870e+11 +87 8.7000000000e-01 8.5923929670e+09 1.2006010050e+11 +88 8.8000000000e-01 7.4650248040e+09 1.0430756970e+11 +89 8.9000000000e-01 6.4855734070e+09 9.0621855610e+10 +90 9.0000000000e-01 5.6346312990e+09 7.8731780830e+10 +91 9.1000000000e-01 4.8953373730e+09 6.8401747800e+10 +92 9.2000000000e-01 4.2530427840e+09 5.9427070660e+10 +93 9.3000000000e-01 3.6950207000e+09 5.1629919420e+10 +94 9.4000000000e-01 3.2102141140e+09 4.4855796350e+10 +95 9.5000000000e-01 2.7890167600e+09 3.8970474660e+10 +96 9.6000000000e-01 2.4230827630e+09 3.3857338820e+10 +97 9.7000000000e-01 2.1051612740e+09 2.9415073900e+10 +98 9.8000000000e-01 1.8289527940e+09 2.5555658020e+10 +99 9.9000000000e-01 1.5889843520e+09 2.2202618260e+10 +100 1.0000000000e+00 1.3805010610e+09 1.9289515350e+10 +101 1.0100000000e+00 1.1993718980e+09 1.6758627210e+10 +102 1.0200000000e+00 1.0420078550e+09 1.4559805200e+10 +103 1.0300000000e+00 9.0529082110e+08 1.2649480460e+10 +104 1.0400000000e+00 7.8651179720e+08 1.0989800600e+10 +105 1.0500000000e+00 6.8331721990e+08 9.5478796640e+09 +106 1.0600000000e+00 5.9366232610e+08 8.2951465080e+09 +107 1.0700000000e+00 5.1577063650e+08 7.2067786790e+09 +108 1.0800000000e+00 4.4809875540e+08 6.2612105610e+09 +109 1.0900000000e+00 3.8930578900e+08 5.4397060660e+09 +110 1.1000000000e+00 3.3822677600e+08 4.7259873780e+09 +111 1.1100000000e+00 2.9384960420e+08 4.1059124200e+09 +112 1.1200000000e+00 2.5529495590e+08 3.5671946310e+09 +113 1.1300000000e+00 2.2179888490e+08 3.0991595130e+09 +114 1.1400000000e+00 1.9269767840e+08 2.6925331190e+09 +115 1.1500000000e+00 1.6741470680e+08 2.3392582940e+09 +116 1.1600000000e+00 1.4544899700e+08 2.0323350270e+09 +117 1.1700000000e+00 1.2636530640e+08 1.7656817420e+09 +118 1.1800000000e+00 1.0978549870e+08 1.5340148030e+09 +119 1.1900000000e+00 9.5381050880e+07 1.3327438110e+09 +120 1.2000000000e+00 8.2866544090e+07 1.1578806560e+09 +121 1.2100000000e+00 7.1994007890e+07 1.0059604880e+09 +122 1.2200000000e+00 6.2548006910e+07 8.7397306220e+08 +123 1.2300000000e+00 5.4341372050e+07 7.5930309660e+08 +124 1.2400000000e+00 4.7211491810e+07 6.5967844720e+08 +125 1.2500000000e+00 4.1017090210e+07 5.7312508750e+08 +126 1.2600000000e+00 3.5635427400e+07 4.9792799400e+08 +127 1.2700000000e+00 3.0959867700e+07 4.3259716360e+08 +128 1.2800000000e+00 2.6897766570e+07 3.7583808940e+08 +129 1.2900000000e+00 2.3368634950e+07 3.2652611100e+08 +130 1.3000000000e+00 2.0302544380e+07 2.8368412930e+08 +131 1.3100000000e+00 1.7638741380e+07 2.4646324610e+08 +132 1.3200000000e+00 1.5324443660e+07 2.1412594280e+08 +133 1.3300000000e+00 1.3313794240e+07 1.8603146760e+08 +134 1.3400000000e+00 1.1566952840e+07 1.6162313870e+08 +135 1.3500000000e+00 1.0049306430e+07 1.4041731380e+08 +136 1.3600000000e+00 8.7307833840e+06 1.2199380710e+08 +137 1.3700000000e+00 7.5852576540e+06 1.0598756360e+08 +138 1.3800000000e+00 6.5900310600e+06 9.2081425300e+07 +139 1.3900000000e+00 5.7253835470e+06 7.9999847130e+07 +140 1.4000000000e+00 4.9741824370e+06 6.9503436980e+07 +141 1.4100000000e+00 4.3215429520e+06 6.0384212290e+07 +142 1.4200000000e+00 3.7545332780e+06 5.2461478920e+07 +143 1.4300000000e+00 3.2619183220e+06 4.5578250780e+07 +144 1.4400000000e+00 2.8339370970e+06 3.9598139180e+07 +145 1.4500000000e+00 2.4621093100e+06 3.4402650380e+07 +146 1.4600000000e+00 2.1390673290e+06 2.9888837650e+07 +147 1.4700000000e+00 1.8584101920e+06 2.5967261420e+07 +148 1.4800000000e+00 1.6145767810e+06 2.2560217080e+07 +149 1.4900000000e+00 1.4027356250e+06 1.9600195280e+07 +150 1.5000000000e+00 1.2186891680e+06 1.7028544260e+07 +151 1.5100000000e+00 1.0587905960e+06 1.4794307680e+07 +152 1.5200000000e+00 9.1987157580e+05 1.2853214960e+07 +153 1.5300000000e+00 7.9917947840e+05 1.1166804040e+07 +154 1.5400000000e+00 6.9432283320e+05 9.7016592970e+06 +155 1.5500000000e+00 6.0322394380e+05 8.4287494270e+06 +156 1.5600000000e+00 5.2407771850e+05 7.3228521760e+06 +157 1.5700000000e+00 4.5531590360e+05 6.3620545920e+06 +158 1.5800000000e+00 3.9557600860e+05 5.5273188170e+06 +159 1.5900000000e+00 3.4367430900e+05 4.8021048650e+06 +160 1.6000000000e+00 2.9858239160e+05 4.1720428830e+06 +161 1.6100000000e+00 2.5940677620e+05 3.6246484220e+06 +162 1.6200000000e+00 2.2537121220e+05 3.1490750570e+06 +163 1.6300000000e+00 1.9580129720e+05 2.7358994750e+06 +164 1.6400000000e+00 1.7011111410e+05 2.3769347520e+06 +165 1.6500000000e+00 1.4779162110e+05 2.0650681300e+06 +166 1.6600000000e+00 1.2840056570e+05 1.7941200870e+06 +167 1.6700000000e+00 1.1155372100e+05 1.5587218830e+06 +168 1.6800000000e+00 9.6917272910e+04 1.3542091900e+06 +169 1.6900000000e+00 8.4201205530e+04 1.1765296620e+06 +170 1.7000000000e+00 7.3153554570e+04 1.0221626440e+06 +171 1.7100000000e+00 6.3555414830e+04 8.8804940820e+05 +172 1.7200000000e+00 5.5216602630e+04 7.7153255030e+05 +173 1.7300000000e+00 4.7971887440e+04 6.7030333080e+05 +174 1.7400000000e+00 4.1677717830e+04 5.8235592920e+05 +175 1.7500000000e+00 3.6209377130e+04 5.0594769970e+05 +176 1.7600000000e+00 3.1458512140e+04 4.3956464070e+05 +177 1.7700000000e+00 2.7330986170e+04 3.8189139610e+05 +178 1.7800000000e+00 2.3745013820e+04 3.3178519130e+05 +179 1.7900000000e+00 2.0629540310e+04 2.8825319000e+05 +180 1.8000000000e+00 1.7922833690e+04 2.5043282140e+05 +181 1.8100000000e+00 1.5571261530e+04 2.1757468850e+05 +182 1.8200000000e+00 1.3528228280e+04 1.8902771940e+05 +183 1.8300000000e+00 1.1753251980e+04 1.6422626610e+05 +184 1.8400000000e+00 1.0211162120e+04 1.4267889680e+05 +185 1.8500000000e+00 8.8714027380e+03 1.2395865830e+05 +186 1.8600000000e+00 7.7074269920e+03 1.0769461580e+05 +187 1.8700000000e+00 6.6961711240e+03 9.3564503040e+04 +188 1.8800000000e+00 5.8175974640e+03 8.1288337100e+04 +189 1.8900000000e+00 5.0542973920e+03 7.0622870140e+04 +190 1.9000000000e+00 4.3911463950e+03 6.1356769800e+04 +191 1.9100000000e+00 3.8150043740e+03 5.3306431660e+04 +192 1.9200000000e+00 3.3144552850e+03 4.6312341170e+04 +193 1.9300000000e+00 2.8795809280e+03 4.0235912960e+04 +194 1.9400000000e+00 2.5017644250e+03 3.4956744810e+04 +195 1.9500000000e+00 2.1735194790e+03 3.0370231910e+04 +196 1.9600000000e+00 1.8883420360e+03 2.6385494170e+04 +197 1.9700000000e+00 1.6405814060e+03 2.2923575440e+04 +198 1.9800000000e+00 1.4253283030e+03 1.9915879070e+04 +199 1.9900000000e+00 1.2383175650e+03 1.7302808640e+04 +200 2.0000000000e+00 1.0758436410e+03 1.5032587100e+04 +201 2.0100000000e+00 9.3468717030e+02 1.3060230840e+04 +202 2.0200000000e+00 8.1205118730e+02 1.1346658320e+04 +203 2.0300000000e+00 7.0550570470e+02 9.8579157300e+03 +204 2.0400000000e+00 6.1293956240e+02 8.5645041750e+03 +205 2.0500000000e+00 5.3251859570e+02 7.4407951710e+03 +206 2.0600000000e+00 4.6264929230e+02 6.4645228320e+03 +207 2.0700000000e+00 4.0194721720e+02 5.6163426730e+03 +208 2.0800000000e+00 3.4920958090e+02 4.8794483120e+03 +209 2.0900000000e+00 3.0339140600e+02 4.2392384540e+03 +210 2.1000000000e+00 2.6358482200e+02 3.6830275730e+03 +211 2.1100000000e+00 2.2900107590e+02 3.1997945490e+03 +212 2.1200000000e+00 1.9895490330e+02 2.7799642980e+03 +213 2.1300000000e+00 1.7285095010e+02 2.4152180320e+03 +214 2.1400000000e+00 1.5017197590e+02 2.0983284390e+03 +215 2.1500000000e+00 1.3046860510e+02 1.8230164640e+03 +216 2.1600000000e+00 1.1335042260e+02 1.5838269000e+03 +217 2.1700000000e+00 9.8478237570e+01 1.3760202940e+03 +218 2.1800000000e+00 8.5557363230e+01 1.1954790320e+03 +219 2.1900000000e+00 7.4331777090e+01 1.0386257540e+03 +220 2.2000000000e+00 6.4579048210e+01 9.0235246990e+02 +221 2.2100000000e+00 5.6105929810e+01 7.8395897350e+02 +222 2.2200000000e+00 4.8744530110e+01 6.8109934040e+02 +223 2.2300000000e+00 4.2348985630e+01 5.9173544430e+02 +224 2.2400000000e+00 3.6792570990e+01 5.1409657190e+02 +225 2.2500000000e+00 3.1965187820e+01 4.4664433710e+02 +226 2.2600000000e+00 2.7771183280e+01 3.8804219830e+02 +227 2.2700000000e+00 2.4127454700e+01 3.3712897510e+02 +228 2.2800000000e+00 2.0961802900e+01 2.9289584070e+02 +229 2.2900000000e+00 1.8211501630e+01 2.5446633130e+02 +230 2.3000000000e+00 1.5822054690e+01 2.2107898030e+02 +231 2.3100000000e+00 1.3746116030e+01 1.9207222920e+02 +232 2.3200000000e+00 1.1942551680e+01 1.6687131990e+02 +233 2.3300000000e+00 1.0375624680e+01 1.4497690530e+02 +234 2.3400000000e+00 9.0142869290e+00 1.2595515570e+02 +235 2.3500000000e+00 7.8315640090e+00 1.0942916200e+02 +236 2.3600000000e+00 6.8040206970e+00 9.5071467470e+01 +237 2.3700000000e+00 5.9112965930e+00 8.2597579690e+01 +238 2.3800000000e+00 5.1357026910e+00 7.1760333060e+01 +239 2.3900000000e+00 4.4618708810e+00 6.2344991470e+01 +240 2.4000000000e+00 3.8764494280e+00 5.3036352210e+01 +241 2.4100000000e+00 3.3678384170e+00 4.8261295350e+01 +242 2.4200000000e+00 2.8941569300e+00 4.5857614440e+01 +243 2.4300000000e+00 2.4468631800e+00 4.3406963180e+01 +244 2.4400000000e+00 2.0256587860e+00 4.0812932280e+01 +245 2.4500000000e+00 1.6301260100e+00 3.8266641770e+01 +246 2.4600000000e+00 1.2597277660e+00 3.5780026500e+01 +247 2.4700000000e+00 9.1380761130e-01 3.3365021740e+01 +248 2.4800000000e+00 5.9158975140e-01 3.1033562180e+01 +249 2.4900000000e+00 2.9217903890e-01 2.8797954450e+01 +250 2.5000000000e+00 1.4560973470e-02 2.6671263930e+01 +251 2.5100000000e+00 -2.4238415820e-01 2.4661823870e+01 +252 2.5200000000e+00 -4.7981058030e-01 2.2768039630e+01 +253 2.5300000000e+00 -6.9883632600e-01 2.0983874620e+01 +254 2.5400000000e+00 -9.0052909770e-01 1.9303963110e+01 +255 2.5500000000e+00 -1.0859062660e+00 1.7723272100e+01 +256 2.5600000000e+00 -1.2559348720e+00 1.6236768280e+01 +257 2.5700000000e+00 -1.4115316230e+00 1.4839418560e+01 +258 2.5800000000e+00 -1.5535628980e+00 1.3526189880e+01 +259 2.5900000000e+00 -1.6828447430e+00 1.2292001960e+01 +260 2.6000000000e+00 -1.8001428730e+00 1.1131681390e+01 +261 2.6100000000e+00 -1.9061744430e+00 1.0040648660e+01 +262 2.6200000000e+00 -2.0016168960e+00 9.0155628370e+00 +263 2.6300000000e+00 -2.0871168150e+00 8.0536395060e+00 +264 2.6400000000e+00 -2.1632916940e+00 7.1520107860e+00 +265 2.6500000000e+00 -2.2307299330e+00 6.3077675390e+00 +266 2.6600000000e+00 -2.2899908440e+00 5.5180009250e+00 +267 2.6700000000e+00 -2.3416046480e+00 4.7798017190e+00 +268 2.6800000000e+00 -2.3860724750e+00 4.0902608440e+00 +269 2.6900000000e+00 -2.4238663650e+00 3.4464440960e+00 +270 2.7000000000e+00 -2.4554292680e+00 2.8453664940e+00 +271 2.7100000000e+00 -2.4811759890e+00 2.2843626470e+00 +272 2.7200000000e+00 -2.5014979300e+00 1.7614298710e+00 +273 2.7300000000e+00 -2.5167678200e+00 1.2748621430e+00 +274 2.7400000000e+00 -2.5273406710e+00 8.2290948110e-01 +275 2.7500000000e+00 -2.5335537710e+00 4.0379949770e-01 +276 2.7600000000e+00 -2.5357266870e+00 1.5760010280e-02 +277 2.7700000000e+00 -2.5341612640e+00 -3.4298090310e-01 +278 2.7800000000e+00 -2.5291416280e+00 -6.7419561340e-01 +279 2.7900000000e+00 -2.5209341800e+00 -9.7967404420e-01 +280 2.8000000000e+00 -2.5097876030e+00 -1.2612416950e+00 +281 2.8100000000e+00 -2.4959335160e+00 -1.5205003860e+00 +282 2.8200000000e+00 -2.4795897790e+00 -1.7585895080e+00 +283 2.8300000000e+00 -2.4609637910e+00 -1.9764437290e+00 +284 2.8400000000e+00 -2.4402531510e+00 -2.1750280650e+00 +285 2.8500000000e+00 -2.4176456570e+00 -2.3553224700e+00 +286 2.8600000000e+00 -2.3933193080e+00 -2.5183069580e+00 +287 2.8700000000e+00 -2.3674423020e+00 -2.6649614780e+00 +288 2.8800000000e+00 -2.3401730380e+00 -2.7962661310e+00 +289 2.8900000000e+00 -2.3116601130e+00 -2.9132049510e+00 +290 2.9000000000e+00 -2.2820423250e+00 -3.0167697150e+00 +291 2.9100000000e+00 -2.2514488140e+00 -3.1079034930e+00 +292 2.9200000000e+00 -2.2199997690e+00 -3.1874493890e+00 +293 2.9300000000e+00 -2.1878071410e+00 -3.2562082020e+00 +294 2.9400000000e+00 -2.1549747780e+00 -3.3149866360e+00 +295 2.9500000000e+00 -2.1215984330e+00 -3.3645944150e+00 +296 2.9600000000e+00 -2.0877657580e+00 -3.4058413510e+00 +297 2.9700000000e+00 -2.0535563080e+00 -3.4395371300e+00 +298 2.9800000000e+00 -2.0190415380e+00 -3.4664917760e+00 +299 2.9900000000e+00 -1.9842848030e+00 -3.4875215040e+00 +300 3.0000000000e+00 -1.9493413610e+00 -3.5034563820e+00 +301 3.0100000000e+00 -1.9142585830e+00 -3.5150471190e+00 +302 3.0200000000e+00 -1.8790770150e+00 -3.5228910160e+00 +303 3.0300000000e+00 -1.8438314390e+00 -3.5275214590e+00 +304 3.0400000000e+00 -1.8085510860e+00 -3.5289583340e+00 +305 3.0500000000e+00 -1.7732596360e+00 -3.5288908310e+00 +306 3.0600000000e+00 -1.7379752190e+00 -3.5280320940e+00 +307 3.0700000000e+00 -1.7027104110e+00 -3.5253862790e+00 +308 3.0800000000e+00 -1.6674722390e+00 -3.5223395310e+00 +309 3.0900000000e+00 -1.6322621780e+00 -3.5194378970e+00 +310 3.1000000000e+00 -1.5970761530e+00 -3.5173081740e+00 +311 3.1100000000e+00 -1.5619051030e+00 -3.5168447480e+00 +312 3.1200000000e+00 -1.5267378260e+00 -3.5168563320e+00 +313 3.1300000000e+00 -1.4915638140e+00 -3.5177518380e+00 +314 3.1400000000e+00 -1.4563738200e+00 -3.5198200760e+00 +315 3.1500000000e+00 -1.4211598630e+00 -3.5226190880e+00 +316 3.1600000000e+00 -1.3859152220e+00 -3.5260255420e+00 +317 3.1700000000e+00 -1.3506344420e+00 -3.5299136690e+00 +318 3.1800000000e+00 -1.3153133290e+00 -3.5341578930e+00 +319 3.1900000000e+00 -1.2799489510e+00 -3.5386343920e+00 +320 3.2000000000e+00 -1.2445396420e+00 -3.5432253600e+00 +321 3.2100000000e+00 -1.2090851000e+00 -3.5477800910e+00 +322 3.2200000000e+00 -1.1735869120e+00 -3.5520723480e+00 +323 3.2300000000e+00 -1.1380490760e+00 -3.5558443110e+00 +324 3.2400000000e+00 -1.1024780970e+00 -3.5588459720e+00 +325 3.2500000000e+00 -1.0668829990e+00 -3.5606965620e+00 +326 3.2600000000e+00 -1.0312753150e+00 -3.5607083610e+00 +327 3.2700000000e+00 -9.9566909100e-01 -3.5605541570e+00 +328 3.2800000000e+00 -9.6008088680e-01 -3.5579489480e+00 +329 3.2900000000e+00 -9.2452977440e-01 -3.5533045150e+00 +330 3.3000000000e+00 -8.8903733850e-01 -3.5464131370e+00 +331 3.3100000000e+00 -8.5362827280e-01 -3.5368973480e+00 +332 3.3200000000e+00 -8.1833336060e-01 -3.5239572210e+00 +333 3.3300000000e+00 -7.8319245590e-01 -3.5065687200e+00 +334 3.3400000000e+00 -7.4825507930e-01 -3.4837450990e+00 +335 3.3500000000e+00 -7.1358041810e-01 -3.4545190770e+00 +336 3.3600000000e+00 -6.7923732650e-01 -3.4179238010e+00 +337 3.3700000000e+00 -6.4530432520e-01 -3.3729926040e+00 +338 3.3800000000e+00 -6.1186960170e-01 -3.3187588290e+00 +339 3.3900000000e+00 -5.7903101040e-01 -3.2542297980e+00 +340 3.4000000000e+00 -5.4689607220e-01 -3.1783580730e+00 +341 3.4100000000e+00 -5.1558072820e-01 -3.0904661310e+00 +342 3.4200000000e+00 -4.8520310790e-01 -2.9907576290e+00 +343 3.4300000000e+00 -4.5587729660e-01 -2.8798705460e+00 +344 3.4400000000e+00 -4.2771208900e-01 -2.7583688810e+00 +345 3.4500000000e+00 -4.0081098950e-01 -2.6267815840e+00 +346 3.4600000000e+00 -3.7527221170e-01 -2.4856376550e+00 +347 3.4700000000e+00 -3.5118867890e-01 -2.3354660560e+00 +348 3.4800000000e+00 -3.2864802400e-01 -2.1767958410e+00 +349 3.4900000000e+00 -3.0773258900e-01 -2.0101012320e+00 +350 3.5000000000e+00 -2.8851942590e-01 -1.8357436110e+00 +351 3.5100000000e+00 -2.7107800890e-01 -1.6548080920e+00 +352 3.5200000000e+00 -2.5545880110e-01 -1.4699936560e+00 +353 3.5300000000e+00 -2.4168181970e-01 -1.2847553720e+00 +354 3.5400000000e+00 -2.2973434990e-01 -1.1024244830e+00 +355 3.5500000000e+00 -2.1957094400e-01 -9.2627328940e-01 +356 3.5600000000e+00 -2.1111342220e-01 -7.5957368970e-01 +357 3.5700000000e+00 -2.0425087220e-01 -6.0559684560e-01 +358 3.5800000000e+00 -1.9883964940e-01 -4.6761229440e-01 +359 3.5900000000e+00 -1.9470337660e-01 -3.4905079620e-01 +360 3.6000000000e+00 -1.9163294430e-01 -2.5373424880e-01 +361 3.6100000000e+00 -1.8939187810e-01 -1.8353921730e-01 +362 3.6200000000e+00 -1.8774317600e-01 -1.3643213030e-01 +363 3.6300000000e+00 -1.8647614590e-01 -1.0900277830e-01 +364 3.6400000000e+00 -1.8541177300e-01 -1.0217451770e-01 +365 3.6500000000e+00 -1.8440272000e-01 -1.0257729120e-01 +366 3.6600000000e+00 -1.8333332690e-01 -1.1032823210e-01 +367 3.6700000000e+00 -1.8211961100e-01 -1.2921992570e-01 +368 3.6800000000e+00 -1.8070926700e-01 -1.5163890710e-01 +369 3.6900000000e+00 -1.7908166700e-01 -1.7442524050e-01 +370 3.7000000000e+00 -1.7724786040e-01 -1.9407009560e-01 +371 3.7100000000e+00 -1.7524726610e-01 -2.0823224750e-01 +372 3.7200000000e+00 -1.7313113340e-01 -2.1707301960e-01 +373 3.7300000000e+00 -1.7094600210e-01 -2.2155931460e-01 +374 3.7400000000e+00 -1.6873039540e-01 -2.2155890460e-01 +375 3.7500000000e+00 -1.6651481940e-01 -2.2155573260e-01 +376 3.7600000000e+00 -1.6432176310e-01 -2.1804279820e-01 +377 3.7700000000e+00 -1.6216569890e-01 -2.1356882610e-01 +378 3.7800000000e+00 -1.6005308190e-01 -2.0885944940e-01 +379 3.7900000000e+00 -1.5798235030e-01 -2.0472213750e-01 +380 3.8000000000e+00 -1.5594392560e-01 -2.0241705720e-01 +381 3.8100000000e+00 -1.5392117290e-01 -2.0241827750e-01 +382 3.8200000000e+00 -1.5189520660e-01 -2.0277318370e-01 +383 3.8300000000e+00 -1.4984969490e-01 -2.0558456320e-01 +384 3.8400000000e+00 -1.4777182060e-01 -2.0947681570e-01 +385 3.8500000000e+00 -1.4565228170e-01 -2.1411724290e-01 +386 3.8600000000e+00 -1.4348529090e-01 -2.1915859900e-01 +387 3.8700000000e+00 -1.4126857580e-01 -2.2425124170e-01 +388 3.8800000000e+00 -1.3900337870e-01 -2.2904532330e-01 +389 3.8900000000e+00 -1.3669445690e-01 -2.3317711800e-01 +390 3.9000000000e+00 -1.3435008260e-01 -2.3624008380e-01 +391 3.9100000000e+00 -1.3198159090e-01 -2.3798596650e-01 +392 3.9200000000e+00 -1.2960112040e-01 -2.3812682950e-01 +393 3.9300000000e+00 -1.2721935400e-01 -2.3811467960e-01 +394 3.9400000000e+00 -1.2484506660e-01 -2.3702815340e-01 +395 3.9500000000e+00 -1.2248512560e-01 -2.3523949930e-01 +396 3.9600000000e+00 -1.2014449050e-01 -2.3305519030e-01 +397 3.9700000000e+00 -1.1782621320e-01 -2.3066255720e-01 +398 3.9800000000e+00 -1.1553143760e-01 -2.2825101140e-01 +399 3.9900000000e+00 -1.1325940020e-01 -2.2601755080e-01 +400 4.0000000000e+00 -1.1100742940e-01 -2.2417862310e-01 +401 4.0100000000e+00 -1.0877118630e-01 -2.2286349760e-01 +402 4.0200000000e+00 -1.0654586480e-01 -2.2202230410e-01 +403 4.0300000000e+00 -1.0432739300e-01 -2.2154405680e-01 +404 4.0400000000e+00 -1.0211267260e-01 -2.2132766590e-01 +405 4.0500000000e+00 -9.9899579570e-02 -2.2126903570e-01 +406 4.0600000000e+00 -9.7686963680e-02 -2.2125247670e-01 +407 4.0700000000e+00 -9.5474648740e-02 -2.2122106790e-01 +408 4.0800000000e+00 -9.3263432500e-02 -2.2107465710e-01 +409 4.0900000000e+00 -9.1055086710e-02 -2.2070112830e-01 +410 4.1000000000e+00 -8.8852357090e-02 -2.1999541830e-01 +411 4.1100000000e+00 -8.6658837090e-02 -2.1888407060e-01 +412 4.1200000000e+00 -8.4478336830e-02 -2.1738813900e-01 +413 4.1300000000e+00 -8.2314251940e-02 -2.1557604180e-01 +414 4.1400000000e+00 -8.0169437390e-02 -2.1350571680e-01 +415 4.1500000000e+00 -7.8046207450e-02 -2.1123112730e-01 +416 4.1600000000e+00 -7.5946335690e-02 -2.0880628380e-01 +417 4.1700000000e+00 -7.3871055030e-02 -2.0628522250e-01 +418 4.1800000000e+00 -7.1821057660e-02 -2.0372199140e-01 +419 4.1900000000e+00 -6.9796495110e-02 -2.0117226580e-01 +420 4.2000000000e+00 -6.7796978220e-02 -1.9869515570e-01 +421 4.2100000000e+00 -6.5821640000e-02 -1.9632881020e-01 +422 4.2200000000e+00 -6.3869449890e-02 -1.9406713000e-01 +423 4.2300000000e+00 -6.1939528000e-02 -1.9188425280e-01 +424 4.2400000000e+00 -6.0031208040e-02 -1.8975732620e-01 +425 4.2500000000e+00 -5.8144037210e-02 -1.8766499860e-01 +426 4.2600000000e+00 -5.6277776300e-02 -1.8558591260e-01 +427 4.2700000000e+00 -5.4432399640e-02 -1.8349871850e-01 +428 4.2800000000e+00 -5.2608095090e-02 -1.8138206230e-01 +429 4.2900000000e+00 -5.0805264080e-02 -1.7921412530e-01 +430 4.3000000000e+00 -4.9024521580e-02 -1.7697218360e-01 +431 4.3100000000e+00 -4.7266676850e-02 -1.7463962540e-01 +432 4.3200000000e+00 -4.5532637180e-02 -1.7221329340e-01 +433 4.3300000000e+00 -4.3823311560e-02 -1.6969643540e-01 +434 4.3400000000e+00 -4.2139591520e-02 -1.6709130180e-01 +435 4.3500000000e+00 -4.0482351020e-02 -1.6439964880e-01 +436 4.3600000000e+00 -3.8852446520e-02 -1.6162322490e-01 +437 4.3700000000e+00 -3.7250716970e-02 -1.5876378180e-01 +438 4.3800000000e+00 -3.5677983800e-02 -1.5582307140e-01 +439 4.3900000000e+00 -3.4135050920e-02 -1.5280279030e-01 +440 4.4000000000e+00 -3.2622704710e-02 -1.4970451960e-01 +441 4.4100000000e+00 -3.1141711720e-02 -1.4653058420e-01 +442 4.4200000000e+00 -2.9692807030e-02 -1.4328494170e-01 +443 4.4300000000e+00 -2.8276682610e-02 -1.3997231400e-01 +444 4.4400000000e+00 -2.6893985010e-02 -1.3659730260e-01 +445 4.4500000000e+00 -2.5545315350e-02 -1.3316445100e-01 +446 4.4600000000e+00 -2.4231229320e-02 -1.2967830180e-01 +447 4.4700000000e+00 -2.2952237190e-02 -1.2614339590e-01 +448 4.4800000000e+00 -2.1708803810e-02 -1.2256427830e-01 +449 4.4900000000e+00 -2.0501348580e-02 -1.1894531750e-01 +450 4.5000000000e+00 -1.9330245510e-02 -1.1529053780e-01 +451 4.5100000000e+00 -1.8195816190e-02 -1.1160621010e-01 +452 4.5200000000e+00 -1.7098295100e-02 -1.0790348070e-01 +453 4.5300000000e+00 -1.6037794770e-02 -1.0419576570e-01 +454 4.5400000000e+00 -1.5014298890e-02 -1.0049612610e-01 +455 4.5500000000e+00 -1.4027662260e-02 -9.6817447880e-02 +456 4.5600000000e+00 -1.3077610840e-02 -9.3172619330e-02 +457 4.5700000000e+00 -1.2163741680e-02 -8.9574526510e-02 +458 4.5800000000e+00 -1.1285523010e-02 -8.6036054070e-02 +459 4.5900000000e+00 -1.0442294160e-02 -8.2570683340e-02 +460 4.6000000000e+00 -9.6332655980e-03 -7.9193083800e-02 +461 4.6100000000e+00 -8.8575419760e-03 -7.5910311180e-02 +462 4.6200000000e+00 -8.1142373740e-03 -7.2713282330e-02 +463 4.6300000000e+00 -7.4025905500e-03 -6.9585550720e-02 +464 4.6400000000e+00 -6.7219879870e-03 -6.6511783650e-02 +465 4.6500000000e+00 -6.0719638950e-03 -6.3477208480e-02 +466 4.6600000000e+00 -5.4522002110e-03 -6.0467053010e-02 +467 4.6700000000e+00 -4.8625265960e-03 -5.7466544920e-02 +468 4.6800000000e+00 -4.3029204390e-03 -5.4460911670e-02 +469 4.6900000000e+00 -3.7735068550e-03 -5.1434523580e-02 +470 4.7000000000e+00 -3.2745586850e-03 -4.8370043780e-02 +471 4.7100000000e+00 -2.8064617420e-03 -4.5261307720e-02 +472 4.7200000000e+00 -2.3695410370e-03 -4.2126515780e-02 +473 4.7300000000e+00 -1.9638870030e-03 -3.8995268370e-02 +474 4.7400000000e+00 -1.5893207430e-03 -3.5895375370e-02 +475 4.7500000000e+00 -1.2453940290e-03 -3.2853768170e-02 +476 4.7600000000e+00 -9.3138930210e-04 -2.9897377850e-02 +477 4.7700000000e+00 -6.4631967200e-04 -2.7053134890e-02 +478 4.7800000000e+00 -3.8892891730e-04 -2.4347968780e-02 +479 4.7900000000e+00 -1.5769148580e-04 -2.1809973910e-02 +480 4.8000000000e+00 4.9187505960e-05 -1.9469671160e-02 +481 4.8100000000e+00 2.3372925440e-04 -1.7342891530e-02 +482 4.8200000000e+00 3.9796617840e-04 -1.5415189150e-02 +483 4.8300000000e+00 5.4372682880e-04 -1.3658952380e-02 +484 4.8400000000e+00 6.7259287050e-04 -1.2048522610e-02 +485 4.8500000000e+00 7.8589908240e-04 -1.0559209690e-02 +486 4.8600000000e+00 8.8473335710e-04 -9.1663247630e-03 +487 4.8700000000e+00 9.6993670140e-04 -7.8451808230e-03 +488 4.8800000000e+00 1.0421032360e-03 -6.5710929150e-03 +489 4.8900000000e+00 1.1015801950e-03 -5.3185837070e-03 +490 4.9000000000e+00 1.1484679270e-03 -4.0606536610e-03 +491 4.9100000000e+00 1.1826519980e-03 -2.7805919490e-03 +492 4.9200000000e+00 1.2039636980e-03 -1.4840911740e-03 +493 4.9300000000e+00 1.2123405590e-03 -1.8744637850e-04 +494 4.9400000000e+00 1.2078584520e-03 1.0946955090e-03 +495 4.9500000000e+00 1.1907315900e-03 2.3485018540e-03 +496 4.9600000000e+00 1.1613125250e-03 3.5601402240e-03 +497 4.9700000000e+00 1.1200921520e-03 4.7157788300e-03 +498 4.9800000000e+00 1.0676997050e-03 5.8015868510e-03 +499 4.9900000000e+00 1.0049027610e-03 6.8031822230e-03 +500 5.0000000000e+00 9.3260723520e-04 7.7050078140e-03 +501 5.0100000000e+00 8.5183745480e-04 8.4983969340e-03 +502 5.0200000000e+00 7.6363650240e-04 9.1887805930e-03 +503 5.0300000000e+00 6.6896656300e-04 9.7875612980e-03 +504 5.0400000000e+00 5.6868899310e-04 1.0305252310e-02 +505 5.0500000000e+00 4.6356432080e-04 1.0751939230e-02 +506 5.0600000000e+00 3.5425224560e-04 1.1137708580e-02 +507 5.0700000000e+00 2.4131163850e-04 1.1472647570e-02 +508 5.0800000000e+00 1.2520054220e-04 1.1766843320e-02 +509 5.0900000000e+00 6.2761706890e-06 1.2030583530e-02 +510 5.1000000000e+00 -1.1520509050e-04 1.2274519120e-02 +511 5.1100000000e+00 -2.3908004220e-04 1.2506742270e-02 +512 5.1200000000e+00 -3.6524046290e-04 1.2730078350e-02 +513 5.1300000000e+00 -4.9359489830e-04 1.2944907750e-02 +514 5.1400000000e+00 -6.2406102030e-04 1.3151960710e-02 +515 5.1500000000e+00 -7.5656562640e-04 1.3352149800e-02 +516 5.1600000000e+00 -8.9104464010e-04 1.3546387640e-02 +517 5.1700000000e+00 -1.0274431110e-03 1.3735586810e-02 +518 5.1800000000e+00 -1.1657152140e-03 1.3920659690e-02 +519 5.1900000000e+00 -1.3058242490e-03 1.4102349940e-02 +520 5.2000000000e+00 -1.4477426450e-03 1.4281081480e-02 +521 5.2100000000e+00 -1.5914586660e-03 1.4459496790e-02 +522 5.2200000000e+00 -1.7370099740e-03 1.4644838790e-02 +523 5.2300000000e+00 -1.8845171920e-03 1.4846534220e-02 +524 5.2400000000e+00 -2.0341906130e-03 1.5073718280e-02 +525 5.2500000000e+00 -2.1863302000e-03 1.5335361050e-02 +526 5.2600000000e+00 -2.3413255880e-03 1.5640434670e-02 +527 5.2700000000e+00 -2.4996560810e-03 1.5997911230e-02 +528 5.2800000000e+00 -2.6618906560e-03 1.6416762160e-02 +529 5.2900000000e+00 -2.8286879610e-03 1.6906373970e-02 +530 5.3000000000e+00 -3.0007963120e-03 1.7477007110e-02 +531 5.3100000000e+00 -3.1790339990e-03 1.8133074970e-02 +532 5.3200000000e+00 -3.3641907710e-03 1.8865012170e-02 +533 5.3300000000e+00 -3.5569293410e-03 1.9656413040e-02 +534 5.3400000000e+00 -3.7577656750e-03 2.0492060870e-02 +535 5.3500000000e+00 -3.9670690000e-03 2.1357287210e-02 +536 5.3600000000e+00 -4.1850618000e-03 2.2237421170e-02 +537 5.3700000000e+00 -4.4118198130e-03 2.3117792040e-02 +538 5.3800000000e+00 -4.6472720400e-03 2.3983729020e-02 +539 5.3900000000e+00 -4.8912007360e-03 2.4820173120e-02 +540 5.4000000000e+00 -5.1432414150e-03 2.5611246230e-02 +541 5.4100000000e+00 -5.4028974590e-03 2.6345995690e-02 +542 5.4200000000e+00 -5.6696131800e-03 2.7023783330e-02 +543 5.4300000000e+00 -5.9428468820e-03 2.7648494840e-02 +544 5.4400000000e+00 -6.2220854650e-03 2.8223326690e-02 +545 5.4500000000e+00 -6.5068444350e-03 2.8751139070e-02 +546 5.4600000000e+00 -6.7966678950e-03 2.9234792020e-02 +547 5.4700000000e+00 -7.0911285520e-03 2.9677145900e-02 +548 5.4800000000e+00 -7.3898277130e-03 3.0081060730e-02 +549 5.4900000000e+00 -7.6923952860e-03 3.0449630790e-02 +550 5.5000000000e+00 -7.9984897810e-03 3.0786428800e-02 +551 5.5100000000e+00 -8.3077897170e-03 3.1092132900e-02 +552 5.5200000000e+00 -8.6199506760e-03 3.1361354280e-02 +553 5.5300000000e+00 -8.9345623430e-03 3.1586068180e-02 +554 5.5400000000e+00 -9.2511399250e-03 3.1758727190e-02 +555 5.5500000000e+00 -9.5691241460e-03 3.1872314690e-02 +556 5.5600000000e+00 -9.8878812460e-03 3.1879060490e-02 +557 5.5700000000e+00 -1.0206702980e-02 3.1879343290e-02 +558 5.5800000000e+00 -1.0524806640e-02 3.1775291070e-02 +559 5.5900000000e+00 -1.0841335000e-02 3.1575078260e-02 +560 5.6000000000e+00 -1.1155356390e-02 3.1277094940e-02 +561 5.6100000000e+00 -1.1465874190e-02 3.0876002420e-02 +562 5.6200000000e+00 -1.1771874720e-02 3.0373359010e-02 +563 5.6300000000e+00 -1.2072375040e-02 2.9774158060e-02 +564 5.6400000000e+00 -1.2366432510e-02 2.9082718780e-02 +565 5.6500000000e+00 -1.2653144820e-02 2.8303067980e-02 +566 5.6600000000e+00 -1.2931649940e-02 2.7439235100e-02 +567 5.6700000000e+00 -1.3201126190e-02 2.6495251650e-02 +568 5.6800000000e+00 -1.3460792170e-02 2.5475145970e-02 +569 5.6900000000e+00 -1.3709906810e-02 2.4382869130e-02 +570 5.7000000000e+00 -1.3947769340e-02 2.3222203640e-02 +571 5.7100000000e+00 -1.4173722750e-02 2.1998018300e-02 +572 5.7200000000e+00 -1.4387171000e-02 2.0717601730e-02 +573 5.7300000000e+00 -1.4587596210e-02 1.9389388150e-02 +574 5.7400000000e+00 -1.4774562110e-02 1.8021631230e-02 +575 5.7500000000e+00 -1.4947714070e-02 1.6622492240e-02 +576 5.7600000000e+00 -1.5106779050e-02 1.5200129840e-02 +577 5.7700000000e+00 -1.5251565630e-02 1.3762707810e-02 +578 5.7800000000e+00 -1.5381964020e-02 1.2318387210e-02 +579 5.7900000000e+00 -1.5497946030e-02 1.0875476430e-02 +580 5.8000000000e+00 -1.5599565090e-02 9.4425870750e-03 +581 5.8100000000e+00 -1.5686950370e-02 8.0264086870e-03 +582 5.8200000000e+00 -1.5760277400e-02 6.6295090340e-03 +583 5.8300000000e+00 -1.5819738700e-02 5.2525609880e-03 +584 5.8400000000e+00 -1.5865537890e-02 3.8965319600e-03 +585 5.8500000000e+00 -1.5897889720e-02 2.5625313690e-03 +586 5.8600000000e+00 -1.5917020020e-02 1.2516718340e-03 +587 5.8700000000e+00 -1.5923165770e-02 -3.4937058100e-05 +588 5.8800000000e+00 -1.5916575010e-02 -1.2961843800e-03 +589 5.8900000000e+00 -1.5897506940e-02 -2.5310939070e-03 +590 5.9000000000e+00 -1.5866231840e-02 -3.7389705170e-03 +591 5.9100000000e+00 -1.5823036470e-02 -4.9173578470e-03 +592 5.9200000000e+00 -1.5768250830e-02 -6.0600357120e-03 +593 5.9300000000e+00 -1.5702275000e-02 -7.1590688840e-03 +594 5.9400000000e+00 -1.5625584430e-02 -8.2067883000e-03 +595 5.9500000000e+00 -1.5538730000e-02 -9.1956535530e-03 +596 5.9600000000e+00 -1.5442337980e-02 -1.0118124370e-02 +597 5.9700000000e+00 -1.5337110070e-02 -1.0966662250e-02 +598 5.9800000000e+00 -1.5223823350e-02 -1.1733731860e-02 +599 5.9900000000e+00 -1.5103330310e-02 -1.2411346770e-02 +600 6.0000000000e+00 -1.4976558850e-02 -1.2990539800e-02 +601 6.0100000000e+00 -1.4844496760e-02 -1.3467852250e-02 +602 6.0200000000e+00 -1.4708114030e-02 -1.3850882370e-02 +603 6.0300000000e+00 -1.4568285260e-02 -1.4151686870e-02 +604 6.0400000000e+00 -1.4425774100e-02 -1.4381668920e-02 +605 6.0500000000e+00 -1.4281233220e-02 -1.4551925990e-02 +606 6.0600000000e+00 -1.4135204390e-02 -1.4673570400e-02 +607 6.0700000000e+00 -1.3988118420e-02 -1.4757756220e-02 +608 6.0800000000e+00 -1.3840295150e-02 -1.4815688990e-02 +609 6.0900000000e+00 -1.3691943500e-02 -1.4859029650e-02 +610 6.1000000000e+00 -1.3543161430e-02 -1.4899772950e-02 +611 6.1100000000e+00 -1.3393954760e-02 -1.4944650430e-02 +612 6.1200000000e+00 -1.3244331080e-02 -1.4987875210e-02 +613 6.1300000000e+00 -1.3094393730e-02 -1.4999195980e-02 +614 6.1400000000e+00 -1.2944360580e-02 -1.5000406620e-02 +615 6.1500000000e+00 -1.2794564020e-02 -1.4968741120e-02 +616 6.1600000000e+00 -1.2645450970e-02 -1.4878631960e-02 +617 6.1700000000e+00 -1.2497582900e-02 -1.4726360280e-02 +618 6.1800000000e+00 -1.2351635780e-02 -1.4500650680e-02 +619 6.1900000000e+00 -1.2208400130e-02 -1.4189602640e-02 +620 6.2000000000e+00 -1.2068780980e-02 -1.3780088450e-02 +621 6.2100000000e+00 -1.1933770350e-02 -1.3266656360e-02 +622 6.2200000000e+00 -1.1804309490e-02 -1.2663757970e-02 +623 6.2300000000e+00 -1.1681151160e-02 -1.1995648740e-02 +624 6.2400000000e+00 -1.1564832050e-02 -1.1284711830e-02 +625 6.2500000000e+00 -1.1455672780e-02 -1.0552530900e-02 +626 6.2600000000e+00 -1.1353777930e-02 -9.8206944580e-03 +627 6.2700000000e+00 -1.1259036020e-02 -9.1107917220e-03 +628 6.2800000000e+00 -1.1171119520e-02 -8.4444087170e-03 +629 6.2900000000e+00 -1.1089484820e-02 -7.8440382630e-03 +630 6.3000000000e+00 -1.1013372280e-02 -7.3343059900e-03 +631 6.3100000000e+00 -1.0941837570e-02 -6.9286062890e-03 +632 6.3200000000e+00 -1.0873908590e-02 -6.6177004520e-03 +633 6.3300000000e+00 -1.0808742380e-02 -6.3836149380e-03 +634 6.3400000000e+00 -1.0745656480e-02 -6.2096675710e-03 +635 6.3500000000e+00 -1.0684128980e-02 -6.0797276050e-03 +636 6.3600000000e+00 -1.0623798440e-02 -5.9776679450e-03 +637 6.3700000000e+00 -1.0564463980e-02 -5.8875005540e-03 +638 6.3800000000e+00 -1.0506085210e-02 -5.7934100960e-03 +639 6.3900000000e+00 -1.0448782260e-02 -5.6790958870e-03 +640 6.4000000000e+00 -1.0392835790e-02 -5.5272351870e-03 +641 6.4100000000e+00 -1.0338663800e-02 -5.3265489450e-03 +642 6.4200000000e+00 -1.0286705990e-02 -5.0824779890e-03 +643 6.4300000000e+00 -1.0237307970e-02 -4.8090647670e-03 +644 6.4400000000e+00 -1.0190698140e-02 -4.5186980020e-03 +645 6.4500000000e+00 -1.0146987700e-02 -4.2230772190e-03 +646 6.4600000000e+00 -1.0106170660e-02 -3.9339072730e-03 +647 6.4700000000e+00 -1.0068123810e-02 -3.6628907880e-03 +648 6.4800000000e+00 -1.0032606730e-02 -3.4217128560e-03 +649 6.4900000000e+00 -9.9992617940e-03 -3.2226936060e-03 +650 6.5000000000e+00 -9.9676141880e-03 -3.0800614930e-03 +651 6.5100000000e+00 -9.9370921530e-03 -3.0007974900e-03 +652 6.5200000000e+00 -9.9071283790e-03 -2.9895971810e-03 +653 6.5300000000e+00 -9.8772613860e-03 -2.9909390270e-03 +654 6.5400000000e+00 -9.8471557910e-03 -3.0244442110e-03 +655 6.5500000000e+00 -9.8166023160e-03 -3.0807584720e-03 +656 6.5600000000e+00 -9.7855177830e-03 -3.1389446580e-03 +657 6.5700000000e+00 -9.7539451160e-03 -3.1876831780e-03 +658 6.5800000000e+00 -9.7220533400e-03 -3.1902459520e-03 +659 6.5900000000e+00 -9.6901375810e-03 -3.1905666810e-03 +660 6.6000000000e+00 -9.6586190680e-03 -3.1317577790e-03 +661 6.6100000000e+00 -9.6280205840e-03 -3.0113946400e-03 +662 6.6200000000e+00 -9.5988437380e-03 -2.8430708940e-03 +663 6.6300000000e+00 -9.5714462370e-03 -2.6468063050e-03 +664 6.6400000000e+00 -9.5460173390e-03 -2.4401082740e-03 +665 6.6500000000e+00 -9.5225778510e-03 -2.2397114760e-03 +666 6.6600000000e+00 -9.5009801320e-03 -2.0623027660e-03 +667 6.6700000000e+00 -9.4809080910e-03 -1.9242058160e-03 +668 6.6800000000e+00 -9.4618771900e-03 -1.8756816070e-03 +669 6.6900000000e+00 -9.4432344390e-03 -1.8737538630e-03 +670 6.7000000000e+00 -9.4241584000e-03 -1.9296967320e-03 +671 6.7100000000e+00 -9.4036962210e-03 -2.1193480020e-03 +672 6.7200000000e+00 -9.3809488110e-03 -2.3946186600e-03 +673 6.7300000000e+00 -9.3552560140e-03 -2.7229160010e-03 +674 6.7400000000e+00 -9.3262336490e-03 -3.0756765770e-03 +675 6.7500000000e+00 -9.2937735010e-03 -3.4254765850e-03 +676 6.7600000000e+00 -9.2580433320e-03 -3.7449102950e-03 +677 6.7700000000e+00 -9.2194868700e-03 -4.0068658770e-03 +678 6.7800000000e+00 -9.1788238190e-03 -4.1695216600e-03 +679 6.7900000000e+00 -9.1370498500e-03 -4.1709417970e-03 +680 6.8000000000e+00 -9.0954366100e-03 -4.1531823070e-03 +681 6.8100000000e+00 -9.0554785850e-03 -3.9087191710e-03 +682 6.8200000000e+00 -9.0186274690e-03 -3.5228649830e-03 +683 6.8300000000e+00 -8.9860265190e-03 -3.0396673600e-03 +684 6.8400000000e+00 -8.9584574300e-03 -2.4966871920e-03 +685 6.8500000000e+00 -8.9363403360e-03 -1.9298633360e-03 +686 6.8600000000e+00 -8.9197338070e-03 -1.3752156630e-03 +687 6.8700000000e+00 -8.9083348510e-03 -8.6872626790e-04 +688 6.8800000000e+00 -8.9014789130e-03 -4.4613382030e-04 +689 6.8900000000e+00 -8.8981398760e-03 -1.4464164490e-04 +690 6.9000000000e+00 -8.8969300610e-03 -9.3306974460e-05 +691 6.9100000000e+00 -8.8961599030e-03 -9.4842573110e-05 +692 6.9200000000e+00 -8.8941363350e-03 -2.6951752300e-04 +693 6.9300000000e+00 -8.8894611720e-03 -6.0677709890e-04 +694 6.9400000000e+00 -8.8810907890e-03 -1.0295850060e-03 +695 6.9500000000e+00 -8.8683361180e-03 -1.5032386040e-03 +696 6.9600000000e+00 -8.8508626520e-03 -1.9925371240e-03 +697 6.9700000000e+00 -8.8286904430e-03 -2.4622017850e-03 +698 6.9800000000e+00 -8.8021941000e-03 -2.8770558440e-03 +699 6.9900000000e+00 -8.7721027940e-03 -3.2001665000e-03 +700 7.0000000000e+00 -8.7395002530e-03 -3.3628110830e-03 +701 7.0100000000e+00 -8.7057669680e-03 -3.3616587300e-03 +702 7.0200000000e+00 -8.6722912150e-03 -3.3328724970e-03 +703 7.0300000000e+00 -8.6401800780e-03 -3.1369921780e-03 +704 7.0400000000e+00 -8.6102016490e-03 -2.8836524560e-03 +705 7.0500000000e+00 -8.5827850310e-03 -2.6048254500e-03 +706 7.0600000000e+00 -8.5580203390e-03 -2.3338108210e-03 +707 7.0700000000e+00 -8.5356586960e-03 -2.1036368350e-03 +708 7.0800000000e+00 -8.5151122380e-03 -1.9811072220e-03 +709 7.0900000000e+00 -8.4954541080e-03 -1.9777398690e-03 +710 7.1000000000e+00 -8.4754184640e-03 -2.0225113290e-03 +711 7.1100000000e+00 -8.4534593770e-03 -2.2965828040e-03 +712 7.1200000000e+00 -8.4280453800e-03 -2.7212170120e-03 +713 7.1300000000e+00 -8.3979540000e-03 -3.2510514740e-03 +714 7.1400000000e+00 -8.3623306660e-03 -3.8476514650e-03 +715 7.1500000000e+00 -8.3206887140e-03 -4.4744244140e-03 +716 7.1600000000e+00 -8.2729093820e-03 -5.0946981770e-03 +717 7.1700000000e+00 -8.2192418120e-03 -5.6718145680e-03 +718 7.1800000000e+00 -8.1603030520e-03 -6.1692539840e-03 +719 7.1900000000e+00 -8.0970780500e-03 -6.5487676050e-03 +720 7.2000000000e+00 -8.0309196620e-03 -6.7272229100e-03 +721 7.2100000000e+00 -7.9634907270e-03 -6.7259642140e-03 +722 7.2200000000e+00 -7.8964744890e-03 -6.6789598430e-03 +723 7.2300000000e+00 -7.8312850050e-03 -6.4221789350e-03 +724 7.2400000000e+00 -7.7690092330e-03 -6.0751032250e-03 +725 7.2500000000e+00 -7.7104070320e-03 -5.6689224870e-03 +726 7.2600000000e+00 -7.6559111550e-03 -5.2359769820e-03 +727 7.2700000000e+00 -7.6056272590e-03 -4.8087903910e-03 +728 7.2800000000e+00 -7.5593338980e-03 -4.4198555860e-03 +729 7.2900000000e+00 -7.5164825260e-03 -4.1030087070e-03 +730 7.3000000000e+00 -7.4761974950e-03 -3.8973776310e-03 +731 7.3100000000e+00 -7.4373205220e-03 -3.8759720650e-03 +732 7.3200000000e+00 -7.3986330090e-03 -3.8773675230e-03 +733 7.3300000000e+00 -7.3590783700e-03 -4.0015934670e-03 +734 7.3400000000e+00 -7.3178064890e-03 -4.2169764230e-03 +735 7.3500000000e+00 -7.2741737280e-03 -4.4858423140e-03 +736 7.3600000000e+00 -7.2277429200e-03 -4.7879201620e-03 +737 7.3700000000e+00 -7.1782833720e-03 -5.1026918510e-03 +738 7.3800000000e+00 -7.1257708670e-03 -5.4095927810e-03 +739 7.3900000000e+00 -7.0703876590e-03 -5.6872718710e-03 +740 7.4000000000e+00 -7.0125224790e-03 -5.9122800580e-03 +741 7.4100000000e+00 -6.9527445490e-03 -6.0705847630e-03 +742 7.4200000000e+00 -6.8916736910e-03 -6.1675051450e-03 +743 7.4300000000e+00 -6.8298504240e-03 -6.2135136040e-03 +744 7.4400000000e+00 -6.7677099870e-03 -6.2133123600e-03 +745 7.4500000000e+00 -6.7055823390e-03 -6.2119432270e-03 +746 7.4600000000e+00 -6.6436921590e-03 -6.1750902160e-03 +747 7.4700000000e+00 -6.5821588440e-03 -6.1325376130e-03 +748 7.4800000000e+00 -6.5209965140e-03 -6.0933858940e-03 +749 7.4900000000e+00 -6.4601140040e-03 -6.0833932360e-03 +750 7.5000000000e+00 -6.3993148730e-03 -6.0828678280e-03 +751 7.5100000000e+00 -6.3383152770e-03 -6.1110319720e-03 +752 7.5200000000e+00 -6.2768333710e-03 -6.1744378110e-03 +753 7.5300000000e+00 -6.2146787090e-03 -6.2517322550e-03 +754 7.5400000000e+00 -6.1517701230e-03 -6.3316236530e-03 +755 7.5500000000e+00 -6.0881357210e-03 -6.4034456450e-03 +756 7.5600000000e+00 -6.0239128920e-03 -6.4556549940e-03 +757 7.5700000000e+00 -5.9593483000e-03 -6.4558690390e-03 +758 7.5800000000e+00 -5.8947978880e-03 -6.4544047390e-03 +759 7.5900000000e+00 -5.8307268780e-03 -6.3840366970e-03 +760 7.6000000000e+00 -5.7677097690e-03 -6.2482392170e-03 +761 7.6100000000e+00 -5.7064038390e-03 -6.0415350870e-03 +762 7.6200000000e+00 -5.6474166590e-03 -5.7781975640e-03 +763 7.6300000000e+00 -5.5911735990e-03 -5.4820877910e-03 +764 7.6400000000e+00 -5.5378913320e-03 -5.1747939830e-03 +765 7.6500000000e+00 -5.4875778360e-03 -4.8770962220e-03 +766 7.6600000000e+00 -5.4400323880e-03 -4.6097357670e-03 +767 7.6700000000e+00 -5.3948455730e-03 -4.3932287400e-03 +768 7.6800000000e+00 -5.3513992750e-03 -4.2592350550e-03 +769 7.6900000000e+00 -5.3088666840e-03 -4.2582276760e-03 +770 7.7000000000e+00 -5.2662122910e-03 -4.2715994810e-03 +771 7.7100000000e+00 -5.2222317010e-03 -4.4675543320e-03 +772 7.7200000000e+00 -5.1757506940e-03 -4.7782011870e-03 +773 7.7300000000e+00 -5.1258242750e-03 -5.1707250140e-03 +774 7.7400000000e+00 -5.0717764940e-03 -5.6171552670e-03 +775 7.7500000000e+00 -5.0132004380e-03 -6.0907404020e-03 +776 7.7600000000e+00 -4.9499582360e-03 -6.5646596010e-03 +777 7.7700000000e+00 -4.8821810580e-03 -7.0120917520e-03 +778 7.7800000000e+00 -4.8102691140e-03 -7.4062816260e-03 +779 7.7900000000e+00 -4.7348916560e-03 -7.7192866600e-03 +780 7.8000000000e+00 -4.6569869740e-03 -7.9185010720e-03 +781 7.8100000000e+00 -4.5777234760e-03 -7.9357116620e-03 +782 7.8200000000e+00 -4.4983050530e-03 -7.9345538390e-03 +783 7.8300000000e+00 -4.4197764540e-03 -7.8056778610e-03 +784 7.8400000000e+00 -4.3429843580e-03 -7.5886231250e-03 +785 7.8500000000e+00 -4.2685773750e-03 -7.3171269070e-03 +786 7.8600000000e+00 -4.1970060460e-03 -7.0106527050e-03 +787 7.8700000000e+00 -4.1285228410e-03 -6.6888898820e-03 +788 7.8800000000e+00 -4.0631821630e-03 -6.3715753420e-03 +789 7.8900000000e+00 -4.0008403430e-03 -6.0790957490e-03 +790 7.9000000000e+00 -3.9411556450e-03 -5.8334960980e-03 +791 7.9100000000e+00 -3.8836100890e-03 -5.6490249270e-03 +792 7.9200000000e+00 -3.8276185730e-03 -5.5238274960e-03 +793 7.9300000000e+00 -3.7726380060e-03 -5.4503718460e-03 +794 7.9400000000e+00 -3.7181891260e-03 -5.4368290110e-03 +795 7.9500000000e+00 -3.6638565070e-03 -5.4375412710e-03 +796 7.9600000000e+00 -3.6092885500e-03 -5.4693271350e-03 +797 7.9700000000e+00 -3.5541974930e-03 -5.5364281040e-03 +798 7.9800000000e+00 -3.4983594020e-03 -5.6225227740e-03 +799 7.9900000000e+00 -3.4416141800e-03 -5.7213422600e-03 +800 8.0000000000e+00 -3.3838655570e-03 -5.8264552150e-03 +801 8.0100000000e+00 -3.3250799920e-03 -5.9317600090e-03 +802 8.0200000000e+00 -3.2652811390e-03 -6.0319529100e-03 +803 8.0300000000e+00 -3.2045443190e-03 -6.1220872130e-03 +804 8.0400000000e+00 -3.1429954090e-03 -6.1971772310e-03 +805 8.0500000000e+00 -3.0808108470e-03 -6.2523344830e-03 +806 8.0600000000e+00 -3.0182176310e-03 -6.2681669500e-03 +807 8.0700000000e+00 -2.9554933170e-03 -6.2687770620e-03 +808 8.0800000000e+00 -2.8929660200e-03 -6.2432932110e-03 +809 8.0900000000e+00 -2.8310144160e-03 -6.1668903030e-03 +810 8.1000000000e+00 -2.7700677390e-03 -6.0438459020e-03 +811 8.1100000000e+00 -2.7105918050e-03 -5.8720071740e-03 +812 8.1200000000e+00 -2.6530191240e-03 -5.6595409670e-03 +813 8.1300000000e+00 -2.5976790150e-03 -5.4196416380e-03 +814 8.1400000000e+00 -2.5447836260e-03 -5.1644165190e-03 +815 8.1500000000e+00 -2.4944279380e-03 -4.9055584030e-03 +816 8.1600000000e+00 -2.4465897580e-03 -4.6547632950e-03 +817 8.1700000000e+00 -2.4011297280e-03 -4.4237188540e-03 +818 8.1800000000e+00 -2.3577913170e-03 -4.2240813640e-03 +819 8.1900000000e+00 -2.3162008250e-03 -4.0681406080e-03 +820 8.2000000000e+00 -2.2758673830e-03 -3.9706319740e-03 +821 8.2100000000e+00 -2.2362029790e-03 -3.9611717460e-03 +822 8.2200000000e+00 -2.1966225940e-03 -3.9620151530e-03 +823 8.2300000000e+00 -2.1566443350e-03 -4.0194821090e-03 +824 8.2400000000e+00 -2.1159094640e-03 -4.1138208480e-03 +825 8.2500000000e+00 -2.0741823980e-03 -4.2252451690e-03 +826 8.2600000000e+00 -2.0313507070e-03 -4.3416947870e-03 +827 8.2700000000e+00 -1.9874251180e-03 -4.4510024540e-03 +828 8.2800000000e+00 -1.9425395100e-03 -4.5411700940e-03 +829 8.2900000000e+00 -1.8969509160e-03 -4.5850896530e-03 +830 8.3000000000e+00 -1.8510395260e-03 -4.5858122980e-03 +831 8.3100000000e+00 -1.8052902620e-03 -4.5663005390e-03 +832 8.3200000000e+00 -1.7602006790e-03 -4.4744051230e-03 +833 8.3300000000e+00 -1.7161888630e-03 -4.3453380180e-03 +834 8.3400000000e+00 -1.6735750130e-03 -4.1893095180e-03 +835 8.3500000000e+00 -1.6325814350e-03 -4.0160059210e-03 +836 8.3600000000e+00 -1.5933325480e-03 -3.8351750510e-03 +837 8.3700000000e+00 -1.5558548830e-03 -3.6565797610e-03 +838 8.3800000000e+00 -1.5200770810e-03 -3.4899795860e-03 +839 8.3900000000e+00 -1.4858298910e-03 -3.3455567640e-03 +840 8.4000000000e+00 -1.4528461780e-03 -3.2346895450e-03 +841 8.4100000000e+00 -1.4207748020e-03 -3.1637014420e-03 +842 8.4200000000e+00 -1.3892500700e-03 -3.1291533650e-03 +843 8.4300000000e+00 -1.3579611770e-03 -3.1292408310e-03 +844 8.4400000000e+00 -1.3266660940e-03 -3.1298911790e-03 +845 8.4500000000e+00 -1.2951915690e-03 -3.1576610340e-03 +846 8.4600000000e+00 -1.2634331300e-03 -3.1917512150e-03 +847 8.4700000000e+00 -1.2313550790e-03 -3.2259651180e-03 +848 8.4800000000e+00 -1.1989904980e-03 -3.2540630400e-03 +849 8.4900000000e+00 -1.1664412430e-03 -3.2555693480e-03 +850 8.5000000000e+00 -1.1338779510e-03 -3.2557025210e-03 +851 8.5100000000e+00 -1.1015326060e-03 -3.2234865450e-03 +852 8.5200000000e+00 -1.0696614040e-03 -3.1630718910e-03 +853 8.5300000000e+00 -1.0385076140e-03 -3.0791159010e-03 +854 8.5400000000e+00 -1.0082941500e-03 -2.9739076870e-03 +855 8.5500000000e+00 -9.7922357050e-04 -2.8494714080e-03 +856 8.5600000000e+00 -9.5147808060e-04 -2.7078379130e-03 +857 8.5700000000e+00 -9.2521952960e-04 -2.5510405740e-03 +858 8.5800000000e+00 -9.0058941240e-04 -2.3811136250e-03 +859 8.5900000000e+00 -8.7770886890e-04 -2.2000297810e-03 +860 8.6000000000e+00 -8.5667868430e-04 -2.0096305180e-03 +861 8.6100000000e+00 -8.3757669380e-04 -1.8125777800e-03 +862 8.6200000000e+00 -8.2044480670e-04 -1.6133743580e-03 +863 8.6300000000e+00 -8.0527603090e-04 -1.4173768830e-03 +864 8.6400000000e+00 -7.9201187730e-04 -1.2297980360e-03 +865 8.6500000000e+00 -7.8054236030e-04 -1.0557824940e-03 +866 8.6600000000e+00 -7.7070599730e-04 -9.0047077190e-04 +867 8.6700000000e+00 -7.6228980900e-04 -7.6899201130e-04 +868 8.6800000000e+00 -7.5502931930e-04 -6.6643613270e-04 +869 8.6900000000e+00 -7.4860855550e-04 -5.9822957020e-04 +870 8.7000000000e+00 -7.4266004790e-04 -5.9102166820e-04 +871 8.7100000000e+00 -7.3677624910e-04 -5.9136220610e-04 +872 8.7200000000e+00 -7.3056662870e-04 -6.3841529490e-04 +873 8.7300000000e+00 -7.2371476810e-04 -7.1895190120e-04 +874 8.7400000000e+00 -7.1598977950e-04 -8.1806870680e-04 +875 8.7500000000e+00 -7.0724630570e-04 -9.2737467390e-04 +876 8.7600000000e+00 -6.9742452050e-04 -1.0383773450e-03 +877 8.7700000000e+00 -6.8655012820e-04 -1.1425742970e-03 +878 8.7800000000e+00 -6.7473436410e-04 -1.2315130470e-03 +879 8.7900000000e+00 -6.6217399400e-04 -1.2963584120e-03 +880 8.8000000000e+00 -6.4915131470e-04 -1.3094343440e-03 +881 8.8100000000e+00 -6.3601950570e-04 -1.3089678270e-03 +882 8.8200000000e+00 -6.2312938900e-04 -1.2757712740e-03 +883 8.8300000000e+00 -6.1075618940e-04 -1.2096983960e-03 +884 8.8400000000e+00 -5.9908488620e-04 -1.1299283140e-03 +885 8.8500000000e+00 -5.8821021300e-04 -1.0452584110e-03 +886 8.8600000000e+00 -5.7813665840e-04 -9.6460283190e-04 +887 8.8700000000e+00 -5.6877846530e-04 -8.9678568750e-04 +888 8.8800000000e+00 -5.5995963120e-04 -8.5822913660e-04 +889 8.8900000000e+00 -5.5141390820e-04 -8.5747478260e-04 +890 8.9000000000e+00 -5.4278480290e-04 -8.6716956740e-04 +891 8.9100000000e+00 -5.3364421720e-04 -9.4133837340e-04 +892 8.9200000000e+00 -5.2358565110e-04 -1.0544350220e-03 +893 8.9300000000e+00 -5.1231740570e-04 -1.1904098590e-03 +894 8.9400000000e+00 -4.9968122430e-04 -1.3354564220e-03 +895 8.9500000000e+00 -4.8565229150e-04 -1.4763473930e-03 +896 8.9600000000e+00 -4.7033923410e-04 -1.5999042110e-03 +897 8.9700000000e+00 -4.5398412050e-04 -1.6934097630e-03 +898 8.9800000000e+00 -4.3696246120e-04 -1.7112894550e-03 +899 8.9900000000e+00 -4.1978320830e-04 -1.7124335300e-03 +900 9.0000000000e+00 -4.0308875560e-04 -1.6449196520e-03 +901 9.0100000000e+00 -3.8762791010e-04 -1.4817040520e-03 +902 9.0200000000e+00 -3.7412074740e-04 -1.2491702780e-03 +903 9.0300000000e+00 -3.6312346700e-04 -9.6992461550e-04 +904 9.0400000000e+00 -3.5500136390e-04 -6.6380635360e-04 +905 9.0500000000e+00 -3.4992882860e-04 -3.4982061670e-04 +906 9.0600000000e+00 -3.4788934670e-04 -4.6993457500e-05 +907 9.0700000000e+00 -3.4867549920e-04 2.2568020250e-04 +908 9.0800000000e+00 -3.5188896250e-04 4.4935964540e-04 +909 9.0900000000e+00 -3.5694050820e-04 6.0452910960e-04 +910 9.1000000000e+00 -3.6305000340e-04 6.1763862860e-04 +911 9.1100000000e+00 -3.6927825380e-04 6.1715722710e-04 +912 9.1200000000e+00 -3.7468622130e-04 4.9717594620e-04 +913 9.1300000000e+00 -3.7849424120e-04 2.9714995560e-04 +914 9.1400000000e+00 -3.8011386570e-04 4.8341320950e-05 +915 9.1500000000e+00 -3.7914786360e-04 -2.3046620100e-04 +916 9.1600000000e+00 -3.7539022070e-04 -5.2026924870e-04 +917 9.1700000000e+00 -3.6882613980e-04 -8.0202351890e-04 +918 9.1800000000e+00 -3.5963204020e-04 -1.0567133440e-03 +919 9.1900000000e+00 -3.4817555830e-04 -1.2645602590e-03 +920 9.2000000000e+00 -3.3501554730e-04 -1.4029450680e-03 +921 9.2100000000e+00 -3.2087683960e-04 -1.4283913870e-03 +922 9.2200000000e+00 -3.0652406010e-04 -1.4272958700e-03 +923 9.2300000000e+00 -2.9263543830e-04 -1.3643256150e-03 +924 9.2400000000e+00 -2.7977757160e-04 -1.2322371450e-03 +925 9.2500000000e+00 -2.6840542450e-04 -1.0605904210e-03 +926 9.2600000000e+00 -2.5886232930e-04 -8.6031093940e-04 +927 9.2700000000e+00 -2.5137998560e-04 -6.4249036470e-04 +928 9.2800000000e+00 -2.4607846060e-04 -4.1825876870e-04 +929 9.2900000000e+00 -2.4296618900e-04 -1.9902305240e-04 +930 9.3000000000e+00 -2.4193997290e-04 3.1845693800e-06 +931 9.3100000000e+00 -2.4279467890e-04 1.7966093380e-04 +932 9.3200000000e+00 -2.4527172140e-04 3.2868016980e-04 +933 9.3300000000e+00 -2.4910754640e-04 4.5137591900e-04 +934 9.3400000000e+00 -2.5404332870e-04 5.4842279990e-04 +935 9.3500000000e+00 -2.5982497130e-04 6.2029030100e-04 +936 9.3600000000e+00 -2.6620310570e-04 6.6743896290e-04 +937 9.3700000000e+00 -2.7293309200e-04 6.8128886900e-04 +938 9.3800000000e+00 -2.7977501880e-04 6.8122989380e-04 +939 9.3900000000e+00 -2.8649370290e-04 6.6561682560e-04 +940 9.4000000000e+00 -2.9285868980e-04 6.1822347770e-04 +941 9.4100000000e+00 -2.9864964660e-04 5.4912675690e-04 +942 9.4200000000e+00 -3.0368332670e-04 4.6394228000e-04 +943 9.4300000000e+00 -3.0784053560e-04 3.7019047190e-04 +944 9.4400000000e+00 -3.1107152360e-04 2.7494326710e-04 +945 9.4500000000e+00 -3.1339598590e-04 1.8510907390e-04 +946 9.4600000000e+00 -3.1490306250e-04 1.0756448490e-04 +947 9.4700000000e+00 -3.1575133810e-04 4.8999593660e-05 +948 9.4800000000e+00 -3.1616884250e-04 3.3107920740e-05 +949 9.4900000000e+00 -3.1645305020e-04 3.2380561200e-05 +950 9.5000000000e+00 -3.1697088070e-04 6.3754272530e-05 +951 9.5100000000e+00 -3.1814184860e-04 1.5167878300e-04 +952 9.5200000000e+00 -3.2035381530e-04 2.7601805580e-04 +953 9.5300000000e+00 -3.2387874080e-04 4.2128484640e-04 +954 9.5400000000e+00 -3.2885583420e-04 5.7377933880e-04 +955 9.5500000000e+00 -3.3529155330e-04 7.2032706750e-04 +956 9.5600000000e+00 -3.4305960490e-04 8.4781313400e-04 +957 9.5700000000e+00 -3.5190094460e-04 9.4358916640e-04 +958 9.5800000000e+00 -3.6142377720e-04 9.6133332950e-04 +959 9.5900000000e+00 -3.7110355600e-04 9.6244725480e-04 +960 9.6000000000e+00 -3.8028298350e-04 8.9260370630e-04 +961 9.6100000000e+00 -3.8819947730e-04 7.2570100330e-04 +962 9.6200000000e+00 -3.9412250090e-04 4.8863488130e-04 +963 9.6300000000e+00 -3.9749089540e-04 2.0465082210e-04 +964 9.6400000000e+00 -3.9794034490e-04 -1.0580965950e-04 +965 9.6500000000e+00 -3.9530337710e-04 -4.2315129320e-04 +966 9.6600000000e+00 -3.8960936300e-04 -7.2775947590e-04 +967 9.6700000000e+00 -3.8108451720e-04 -1.0000584900e-03 +968 9.6800000000e+00 -3.7015189750e-04 -1.2206640990e-03 +969 9.6900000000e+00 -3.5743140510e-04 -1.3686784530e-03 +970 9.7000000000e+00 -3.4373978450e-04 -1.3687177910e-03 +971 9.7100000000e+00 -3.3005711180e-04 -1.3677771240e-03 +972 9.7200000000e+00 -3.1735923270e-04 -1.2175506400e-03 +973 9.7300000000e+00 -3.0645020200e-04 -9.9744243200e-04 +974 9.7400000000e+00 -2.9792877150e-04 -7.2818771020e-04 +975 9.7500000000e+00 -2.9218838950e-04 -4.3000627220e-04 +976 9.7600000000e+00 -2.8941720110e-04 -1.2331077010e-04 +977 9.7700000000e+00 -2.8959804820e-04 1.7145429420e-04 +978 9.7800000000e+00 -2.9250846960e-04 4.3389135570e-04 +979 9.7900000000e+00 -2.9772070050e-04 6.4262374950e-04 +980 9.8000000000e+00 -3.0460167320e-04 7.7223408700e-04 +981 9.8100000000e+00 -3.1234484370e-04 7.7669650150e-04 +982 9.8200000000e+00 -3.2012932700e-04 7.7621752470e-04 +983 9.8300000000e+00 -3.2727903260e-04 6.8055189370e-04 +984 9.8400000000e+00 -3.3329449150e-04 5.4117460460e-04 +985 9.8500000000e+00 -3.3785285590e-04 3.7873497620e-04 +986 9.8600000000e+00 -3.4080789960e-04 2.1056974260e-04 +987 9.8700000000e+00 -3.4219001780e-04 5.4129325750e-05 +988 9.8800000000e+00 -3.4220622720e-04 -7.3421138480e-05 +989 9.8900000000e+00 -3.4124016580e-04 -1.2932529480e-04 +990 9.9000000000e+00 -3.3985209320e-04 -1.3027960630e-04 +991 9.9100000000e+00 -3.3874868130e-04 -9.4889177100e-05 +992 9.9200000000e+00 -3.3863196930e-04 4.0847818400e-05 +993 9.9300000000e+00 -3.4004831890e-04 2.2224472680e-04 +994 9.9400000000e+00 -3.4335820470e-04 4.3012047260e-04 +995 9.9500000000e+00 -3.4873621490e-04 6.4610107190e-04 +996 9.9600000000e+00 -3.5617105070e-04 8.5173520200e-04 +997 9.9700000000e+00 -3.6546552680e-04 1.0286755720e-03 +998 9.9800000000e+00 -3.7623657080e-04 1.1593557180e-03 +999 9.9900000000e+00 -3.8791522390e-04 1.1761944840e-03 +1000 1.0000000000e+01 -3.9974664040e-04 1.1767838920e-03 +1001 1.0010000000e+01 -4.1082104180e-04 1.0677225170e-03 +1002 1.0020000000e+01 -4.2022926040e-04 8.5414149960e-04 +1003 1.0030000000e+01 -4.2721876140e-04 5.7407440180e-04 +1004 1.0040000000e+01 -4.3122515020e-04 2.4718443700e-04 +1005 1.0050000000e+01 -4.3187226610e-04 -1.0782601200e-04 +1006 1.0060000000e+01 -4.2897216000e-04 -4.7219506290e-04 +1007 1.0070000000e+01 -4.2252495590e-04 -8.2716579100e-04 +1008 1.0080000000e+01 -4.1271859740e-04 -1.1540259710e-03 +1009 1.0090000000e+01 -3.9992847830e-04 -1.4333717600e-03 +1010 1.0100000000e+01 -3.8471695790e-04 -1.6437078990e-03 +1011 1.0110000000e+01 -3.6780865340e-04 -1.7721885790e-03 +1012 1.0120000000e+01 -3.4996932360e-04 -1.8019117800e-03 +1013 1.0130000000e+01 -3.3188505560e-04 -1.8006379560e-03 +1014 1.0140000000e+01 -3.1413816540e-04 -1.7566778600e-03 +1015 1.0150000000e+01 -2.9720729950e-04 -1.6504364580e-03 +1016 1.0160000000e+01 -2.8146759970e-04 -1.5122390050e-03 +1017 1.0170000000e+01 -2.6719093180e-04 -1.3521402890e-03 +1018 1.0180000000e+01 -2.5454617650e-04 -1.1803480910e-03 +1019 1.0190000000e+01 -2.4359958460e-04 -1.0073204990e-03 +1020 1.0200000000e+01 -2.3431519470e-04 -8.4406428450e-04 +1021 1.0210000000e+01 -2.2656453160e-04 -6.9838951460e-04 +1022 1.0220000000e+01 -2.2017314520e-04 -5.7144880500e-04 +1023 1.0230000000e+01 -2.1496692380e-04 -4.6164139160e-04 +1024 1.0240000000e+01 -2.1078135050e-04 -3.6780651980e-04 +1025 1.0250000000e+01 -2.0746151260e-04 -2.8898365970e-04 +1026 1.0260000000e+01 -2.0486210460e-04 -2.2421250740e-04 +1027 1.0270000000e+01 -2.0284742580e-04 -1.7253368530e-04 +1028 1.0280000000e+01 -2.0129137260e-04 -1.3299015590e-04 +1029 1.0290000000e+01 -2.0007742360e-04 -1.0462481120e-04 +1030 1.0300000000e+01 -1.9909862130e-04 -8.6482093950e-05 +1031 1.0310000000e+01 -1.9825740620e-04 -8.0176145770e-05 +1032 1.0320000000e+01 -1.9746489060e-04 -8.0270475810e-05 +1033 1.0330000000e+01 -1.9664013180e-04 -8.4149519230e-05 +1034 1.0340000000e+01 -1.9570996480e-04 -9.8408753000e-05 +1035 1.0350000000e+01 -1.9460896870e-04 -1.1878674230e-04 +1036 1.0360000000e+01 -1.9327943030e-04 -1.4453939260e-04 +1037 1.0370000000e+01 -1.9167130140e-04 -1.7490855840e-04 +1038 1.0380000000e+01 -1.8974215350e-04 -2.0913698290e-04 +1039 1.0390000000e+01 -1.8745712570e-04 -2.4647791360e-04 +1040 1.0400000000e+01 -1.8478887050e-04 -2.8620364200e-04 +1041 1.0410000000e+01 -1.8171776410e-04 -3.2750670860e-04 +1042 1.0420000000e+01 -1.7823319480e-04 -3.6939422980e-04 +1043 1.0430000000e+01 -1.7433482900e-04 -4.1079442840e-04 +1044 1.0440000000e+01 -1.7003277440e-04 -4.5066219870e-04 +1045 1.0450000000e+01 -1.6534746400e-04 -4.8797153340e-04 +1046 1.0460000000e+01 -1.6030953380e-04 -5.2170945500e-04 +1047 1.0470000000e+01 -1.5495969400e-04 -5.5087748210e-04 +1048 1.0480000000e+01 -1.4934859350e-04 -5.7449468730e-04 +1049 1.0490000000e+01 -1.4353667910e-04 -5.9151095890e-04 +1050 1.0500000000e+01 -1.3759404780e-04 -5.9895751610e-04 +1051 1.0510000000e+01 -1.3159786030e-04 -5.9884024670e-04 +1052 1.0520000000e+01 -1.2562008510e-04 -5.9671537190e-04 +1053 1.0530000000e+01 -1.1971541890e-04 -5.8645497820e-04 +1054 1.0540000000e+01 -1.1391907460e-04 -5.7377073050e-04 +1055 1.0550000000e+01 -1.0824702940e-04 -5.6047034270e-04 +1056 1.0560000000e+01 -1.0269628380e-04 -5.4839149330e-04 +1057 1.0570000000e+01 -9.7245133280e-05 -5.3923980200e-04 +1058 1.0580000000e+01 -9.1853451120e-05 -5.3911449470e-04 +1059 1.0590000000e+01 -8.6462982460e-05 -5.3910199430e-04 +1060 1.0600000000e+01 -8.0997650220e-05 -5.5041729600e-04 +1061 1.0610000000e+01 -7.5368739520e-05 -5.7173059930e-04 +1062 1.0620000000e+01 -6.9499402950e-05 -5.9987988550e-04 +1063 1.0630000000e+01 -6.3348728690e-05 -6.3019444120e-04 +1064 1.0640000000e+01 -5.6916004900e-05 -6.5859860260e-04 +1065 1.0650000000e+01 -5.0240052900e-05 -6.8133908400e-04 +1066 1.0660000000e+01 -4.3398535910e-05 -6.8721567780e-04 +1067 1.0670000000e+01 -3.6507243520e-05 -6.8762860290e-04 +1068 1.0680000000e+01 -2.9719352220e-05 -6.7391683480e-04 +1069 1.0690000000e+01 -2.3224662110e-05 -6.3517303510e-04 +1070 1.0700000000e+01 -1.7248809950e-05 -5.7135297940e-04 +1071 1.0710000000e+01 -1.2043859570e-05 -4.8077252260e-04 +1072 1.0720000000e+01 -7.8448100750e-06 -3.6813962720e-04 +1073 1.0730000000e+01 -4.8270281820e-06 -2.4116727060e-04 +1074 1.0740000000e+01 -3.0987780870e-06 -1.0674709090e-04 +1075 1.0750000000e+01 -2.7024744570e-06 2.8614036460e-05 +1076 1.0760000000e+01 -3.6159753210e-06 1.5853729430e-04 +1077 1.0770000000e+01 -5.7539145360e-06 2.7678298170e-04 +1078 1.0780000000e+01 -8.9690733710e-06 3.7726806870e-04 +1079 1.0790000000e+01 -1.3053790830e-05 4.5374751230e-04 +1080 1.0800000000e+01 -1.7741412250e-05 4.9645783070e-04 +1081 1.0810000000e+01 -2.2717402080e-05 4.9635768930e-04 +1082 1.0820000000e+01 -2.7668550310e-05 4.9373434340e-04 +1083 1.0830000000e+01 -3.2330964780e-05 4.5092721080e-04 +1084 1.0840000000e+01 -3.6498647170e-05 3.9091840760e-04 +1085 1.0850000000e+01 -4.0022298200e-05 3.1893553480e-04 +1086 1.0860000000e+01 -4.2808089230e-05 2.4038641930e-04 +1087 1.0870000000e+01 -4.4816400650e-05 1.6059919060e-04 +1088 1.0880000000e+01 -4.6060527570e-05 8.4780110980e-05 +1089 1.0890000000e+01 -4.6605352970e-05 1.8223653080e-05 +1090 1.0900000000e+01 -4.6565988960e-05 -3.3314987920e-05 +1091 1.0910000000e+01 -4.6099238430e-05 -6.6873796480e-05 +1092 1.0920000000e+01 -4.5366824730e-05 -8.4916136160e-05 +1093 1.0930000000e+01 -4.4499679130e-05 -9.0355700370e-05 +1094 1.0940000000e+01 -4.3591609800e-05 -8.9952927120e-05 +1095 1.0950000000e+01 -4.2700237280e-05 -8.7651375340e-05 +1096 1.0960000000e+01 -4.1847951690e-05 -8.3360830850e-05 +1097 1.0970000000e+01 -4.1022891310e-05 -8.2903739490e-05 +1098 1.0980000000e+01 -4.0179942230e-05 -8.5063482370e-05 +1099 1.0990000000e+01 -3.9241758770e-05 -9.8313192120e-05 +1100 1.1000000000e+01 -3.8099804360e-05 -1.2447822810e-04 +1101 1.1010000000e+01 -3.6621345410e-05 -1.6534170470e-04 +1102 1.1020000000e+01 -3.4679816320e-05 -2.1818064580e-04 +1103 1.1030000000e+01 -3.2184148770e-05 -2.7819907000e-04 +1104 1.1040000000e+01 -2.9083598200e-05 -3.4125702240e-04 +1105 1.1050000000e+01 -2.5366519500e-05 -4.0351991940e-04 +1106 1.1060000000e+01 -2.1059118990e-05 -4.6127744400e-04 +1107 1.1070000000e+01 -1.6224183250e-05 -5.1095646380e-04 +1108 1.1080000000e+01 -1.0959784980e-05 -5.4915926570e-04 +1109 1.1090000000e+01 -5.3979664600e-06 -5.6732102600e-04 +1110 1.1100000000e+01 2.9659907510e-07 -5.6742631160e-04 +1111 1.1110000000e+01 5.9341452010e-06 -5.6066382740e-04 +1112 1.1120000000e+01 1.1331617930e-05 -5.2705013840e-04 +1113 1.1130000000e+01 1.6343217970e-05 -4.8102892890e-04 +1114 1.1140000000e+01 2.0865295550e-05 -4.2682936100e-04 +1115 1.1150000000e+01 2.4834928580e-05 -3.6840379250e-04 +1116 1.1160000000e+01 2.8228476910e-05 -3.0958860270e-04 +1117 1.1170000000e+01 3.1060112970e-05 -2.5407827860e-04 +1118 1.1180000000e+01 3.3380329340e-05 -2.0541192570e-04 +1119 1.1190000000e+01 3.5274423720e-05 -1.6718237570e-04 +1120 1.1200000000e+01 3.6860961690e-05 -1.4358272690e-04 +1121 1.1210000000e+01 3.8283995600e-05 -1.4050599770e-04 +1122 1.1220000000e+01 3.9680922010e-05 -1.4091331570e-04 +1123 1.1230000000e+01 4.1151837300e-05 -1.5145488130e-04 +1124 1.1240000000e+01 4.2754890750e-05 -1.6788298170e-04 +1125 1.1250000000e+01 4.4508020530e-05 -1.8405361040e-04 +1126 1.1260000000e+01 4.6390713930e-05 -1.9455426310e-04 +1127 1.1270000000e+01 4.8345791250e-05 -1.9485241340e-04 +1128 1.1280000000e+01 5.0281212820e-05 -1.9265493800e-04 +1129 1.1290000000e+01 5.2071908600e-05 -1.7208895670e-04 +1130 1.1300000000e+01 5.3561629730e-05 -1.3367792980e-04 +1131 1.1310000000e+01 5.4572080700e-05 -7.6096086180e-05 +1132 1.1320000000e+01 5.4940349260e-05 -3.4911970810e-06 +1133 1.1330000000e+01 5.4554256440e-05 7.7596661070e-05 +1134 1.1340000000e+01 5.3357134590e-05 1.6154909480e-04 +1135 1.1350000000e+01 5.1345125320e-05 2.4323900560e-04 +1136 1.1360000000e+01 4.8564445820e-05 3.1781175050e-04 +1137 1.1370000000e+01 4.5108624410e-05 3.8070237770e-04 +1138 1.1380000000e+01 4.1115706090e-05 4.2768998170e-04 +1139 1.1390000000e+01 3.6765429140e-05 4.4569996240e-04 +1140 1.1400000000e+01 3.2276373320e-05 4.4577483730e-04 +1141 1.1410000000e+01 2.7894657000e-05 4.3230431740e-04 +1142 1.1420000000e+01 2.3849973670e-05 3.8651116970e-04 +1143 1.1430000000e+01 2.0314535340e-05 3.2680232760e-04 +1144 1.1440000000e+01 1.7397851760e-05 2.5938783110e-04 +1145 1.1450000000e+01 1.5150232920e-05 1.8994220910e-04 +1146 1.1460000000e+01 1.3566325960e-05 1.2382271180e-04 +1147 1.1470000000e+01 1.2588685570e-05 6.6028107650e-05 +1148 1.1480000000e+01 1.2111376660e-05 2.1147970850e-05 +1149 1.1490000000e+01 1.1983608170e-05 -5.5445510610e-07 +1150 1.1500000000e+01 1.2013397080e-05 -6.3433927090e-07 +1151 1.1510000000e+01 1.1979618440e-05 6.9224805850e-06 +1152 1.1520000000e+01 1.1676213710e-05 4.4864949350e-05 +1153 1.1530000000e+01 1.0952841300e-05 9.4560562700e-05 +1154 1.1540000000e+01 9.7194851630e-06 1.5011734680e-04 +1155 1.1550000000e+01 7.9423493170e-06 2.0620127250e-04 +1156 1.1560000000e+01 5.6397197640e-06 2.5785045690e-04 +1157 1.1570000000e+01 2.8777951330e-06 3.0053260610e-04 +1158 1.1580000000e+01 -2.3351266940e-07 3.3028724980e-04 +1159 1.1590000000e+01 -3.5448065280e-06 3.3191037270e-04 +1160 1.1600000000e+01 -6.8714595930e-06 3.3193028550e-04 +1161 1.1610000000e+01 -1.0004797940e-05 3.0304498820e-04 +1162 1.1620000000e+01 -1.2749539600e-05 2.5408763700e-04 +1163 1.1630000000e+01 -1.4957470800e-05 1.9293355440e-04 +1164 1.1640000000e+01 -1.6530760420e-05 1.2458386860e-04 +1165 1.1650000000e+01 -1.7418004970e-05 5.3446519620e-05 +1166 1.1660000000e+01 -1.7610248450e-05 -1.6448088780e-05 +1167 1.1670000000e+01 -1.7136978150e-05 -8.1464308840e-05 +1168 1.1680000000e+01 -1.6062097780e-05 -1.3836894190e-04 +1169 1.1690000000e+01 -1.4479879090e-05 -1.8421787100e-04 +1170 1.1700000000e+01 -1.2510893210e-05 -2.1616290120e-04 +1171 1.1710000000e+01 -1.0294430290e-05 -2.3233687030e-04 +1172 1.1720000000e+01 -7.9678780230e-06 -2.3227402260e-04 +1173 1.1730000000e+01 -5.6486954130e-06 -2.3150892740e-04 +1174 1.1740000000e+01 -3.4322545090e-06 -2.1621802220e-04 +1175 1.1750000000e+01 -1.3934204810e-06 -1.9466108350e-04 +1176 1.1760000000e+01 4.1185956270e-07 -1.6850313820e-04 +1177 1.1770000000e+01 1.9449594820e-06 -1.3936779990e-04 +1178 1.1780000000e+01 3.1829692270e-06 -1.0873702930e-04 +1179 1.1790000000e+01 4.1170826780e-06 -7.7937096740e-05 +1180 1.1800000000e+01 4.7509787070e-06 -4.8134899120e-05 +1181 1.1810000000e+01 5.0991788260e-06 -2.0329557190e-05 +1182 1.1820000000e+01 5.1853377300e-06 4.6534024350e-06 +1183 1.1830000000e+01 5.0405482780e-06 2.6153287390e-05 +1184 1.1840000000e+01 4.7017245850e-06 4.3667703640e-05 +1185 1.1850000000e+01 4.2099998780e-06 5.6852853570e-05 +1186 1.1860000000e+01 3.6091206690e-06 6.5520030940e-05 +1187 1.1870000000e+01 2.9438377600e-06 6.8044387790e-05 +1188 1.1880000000e+01 2.2582945630e-06 6.8005776470e-05 +1189 1.1890000000e+01 1.5944132410e-06 6.5247449720e-05 +1190 1.1900000000e+01 9.9027914890e-07 5.7253374050e-05 +1191 1.1910000000e+01 4.7794482020e-07 4.6374107540e-05 +1192 1.1920000000e+01 7.9430367210e-08 3.3872879470e-05 +1193 1.1930000000e+01 -1.9586145530e-07 2.1091406450e-05 +1194 1.1940000000e+01 -3.5038203430e-07 9.1537875640e-06 +1195 1.1950000000e+01 -3.9696232700e-07 -9.8173844310e-07 +1196 1.1960000000e+01 -3.5733509120e-07 -8.5097413050e-06 +1197 1.1970000000e+01 -2.6065437280e-07 -1.1346751290e-05 +1198 1.1980000000e+01 -1.4201270800e-07 -1.1393547340e-05 +1199 1.1990000000e+01 -4.0956496040e-08 -8.7451546660e-06 +1200 1.2000000000e+01 0.0000000000e+00 -1.0906638080e-06 From 48f477e4b4fe4ba38735b6113c9c18c6e65c1a7d Mon Sep 17 00:00:00 2001 From: Christoph Scherer Date: Thu, 26 May 2022 15:19:41 +0200 Subject: [PATCH 221/585] Update pair_sw_3b_table.rst Small correction --- doc/src/pair_sw_3b_table.rst | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/doc/src/pair_sw_3b_table.rst b/doc/src/pair_sw_3b_table.rst index 6ee13eb095..7c648446a5 100644 --- a/doc/src/pair_sw_3b_table.rst +++ b/doc/src/pair_sw_3b_table.rst @@ -1,7 +1,7 @@ -.. index:: pair_style sw_table +.. index:: pair_style sw_3b_table pair_style sw/3b/table command -=========================== +============================== Syntax """""" From 2a7407aa38abc38a6b66d9c11b1bdf819cbed74b Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 26 May 2022 11:41:51 -0400 Subject: [PATCH 222/585] programming style updates --- doc/src/pair_3b_table.rst | 18 ++--- doc/src/pair_sw_3b_table.rst | 4 +- src/.gitignore | 4 + src/MANYBODY/pair_3b_table.cpp | 71 +++++++--------- src/MANYBODY/pair_3b_table.h | 99 ++++++----------------- src/MANYBODY/pair_sw_3b_table.cpp | 130 ++++++++++++------------------ src/MANYBODY/pair_sw_3b_table.h | 84 ++++--------------- 7 files changed, 137 insertions(+), 273 deletions(-) diff --git a/doc/src/pair_3b_table.rst b/doc/src/pair_3b_table.rst index 77d2dc7f1b..ae5e6c2a50 100644 --- a/doc/src/pair_3b_table.rst +++ b/doc/src/pair_3b_table.rst @@ -29,7 +29,7 @@ Description The *3b/table* style is a pair style for generic tabulated three-body interactions. It has been developed for (coarse-grained) simulations (of water) with Kernel-based machine learning (ML) potentials (:ref:`Scherer2 `). -As for the pair style :doc:`pair_style sw ` +As for the pair style :doc:`pair_style sw ` or :doc:`pair_style sw/table `, the energy of a system is computed as a sum over three-body terms: @@ -39,7 +39,7 @@ is computed as a sum over three-body terms: The summations in the formula are over all neighbors J and K of atom I within a cutoff distance :math:`cut`. -In contrast to the Stillinger-Weber potential, all forces are not calculated analytically, but +In contrast to the Stillinger-Weber potential, all forces are not calculated analytically, but read in from a three-body force/energy table which can be generated with the csg_ml app of VOTCA as available at: . @@ -63,7 +63,7 @@ pair_coeff command: .. code-block:: LAMMPS pair_coeff * * SiC.3b Si Si Si C - + The first 2 arguments must be \* \* so as to span all LAMMPS atom types. The first three Si arguments map LAMMPS atom types 1,2,3 to the Si element in the ".3b" file. The final C argument maps LAMMPS atom type 4 @@ -75,7 +75,7 @@ potentials. The three-body files have a ".3b" suffix. Lines that are not blank or comments (starting with #) define parameters for a triplet of -elements. The parameters in a single entry specify to the +elements. The parameters in a single entry specify to the (three-body) cutoff distance and the tabulated three-body interaction. A single entry then contains: @@ -100,18 +100,18 @@ If element 2 and element 3 are of the same type (e.g. SiCC), the distance :math:`r_{ij}` is varied in "N" steps from rmin to rmax and the distance :math:`r_{ik}` is varied from :math:`r_{ij}` to rmax. This can be done, due to the symmetry of the triplet. If element 2 and element 3 are not -of the same type (e.g. SiCSi), there is no additional symmetry and the +of the same type (e.g. SiCSi), there is no additional symmetry and the distance :math:`r_{ik}` is also varied from rmin to rmax in "N" steps. The angle :math:`\theta_{ijk}` is alsways varied in "2N" steps from (0.0 + 180.0/(4N)) to (180.0 - 180.0/(4N)). Therefore, the total number -of table entries is "M = N * N * (N+1)" for the symmetric (element 2 and element 3 +of table entries is "M = N * N * (N+1)" for the symmetric (element 2 and element 3 are of the same type) and "M = 2 * N * N * N" for the general case (element 2 and element 3 are not of the same type). The forces on all three particles I, J, and K of a triplet -of this type of thre-body interaction potential +of this type of thre-body interaction potential (:math:`\phi_3 (r_{ij}, r_{ik}, \theta_{ijk})`) lie within -the plane defined by the three inter-particle distance vectors +the plane defined by the three inter-particle distance vectors :math:`{\mathbf r}_{ij}`, :math:`{\mathbf r}_{ik}`, and :math:`{\mathbf r}_{jk}`. This property is used to project the forces onto the inter-particle distance vectors as follows @@ -215,7 +215,7 @@ principle be specific to the three elements of the configuration. However, the user must ensure that it makes physically sense. E.g., the tabulated three-body forces for the entries CSiC and CCSi should be the same exchanging :math:`r_{ij}` with -r_{ik}, :math:`f_{j1}` with :math:`f_{k1}`, +r_{ik}, :math:`f_{j1}` with :math:`f_{k1}`, and :math:`f_{j2}` with :math:`f_{k2}`. diff --git a/doc/src/pair_sw_3b_table.rst b/doc/src/pair_sw_3b_table.rst index 7c648446a5..97fcb63e34 100644 --- a/doc/src/pair_sw_3b_table.rst +++ b/doc/src/pair_sw_3b_table.rst @@ -112,7 +112,7 @@ The A, B, p, and q parameters are used only for two-body interactions. The :math:`\lambda` and :math:`\cos\theta_0` parameters, only used for three-body interactions in the original Stillinger-Weber style, are read in but ignored in this modified pair style. The :math:`\epsilon` parameter is only used -for two-body interactions in this modified pair style and not for the three-body +for two-body interactions in this modified pair style and not for the three-body terms. The :math:`\sigma` and *a* parameters are used for both two-body and three-body interactions. :math:`\gamma` is used only in the three-body interactions, but is defined for pairs of atoms. The non-annotated @@ -235,7 +235,7 @@ screening factors with parameter values from the ij pair and ik pairs. So :math:`\phi_3` for a C atom bonded to a Si atom and a second C atom will depend on the three-body parameters for the CSiC entry, and also on the two-body parameters for the CCC and CSiSi entries. Since the -order of the two neighbors is arbitrary, the three-body parameters +order of the two neighbors is arbitrary, the three-body parameters and the tabulated angular potential for entries CSiC and CCSi should be the same. Similarly, the two-body parameters for entries SiCC and CSiSi should also be the same. The diff --git a/src/.gitignore b/src/.gitignore index 6657256e8f..de157734fc 100644 --- a/src/.gitignore +++ b/src/.gitignore @@ -997,6 +997,8 @@ /neb.h /netcdf_units.cpp /netcdf_units.h +/pair_3b_table.cpp +/pair_3b_table.h /pair_adp.cpp /pair_adp.h /pair_agni.cpp @@ -1291,6 +1293,8 @@ /pair_sph_taitwater_morris.h /pair_sw.cpp /pair_sw.h +/pair_sw_3b_table.cpp +/pair_sw_3b_table.h /pair_sw_mod.cpp /pair_sw_mod.h /pair_tersoff.cpp diff --git a/src/MANYBODY/pair_3b_table.cpp b/src/MANYBODY/pair_3b_table.cpp index a2227d5161..fd91713af8 100644 --- a/src/MANYBODY/pair_3b_table.cpp +++ b/src/MANYBODY/pair_3b_table.cpp @@ -1,6 +1,6 @@ /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator - http://lammps.sandia.gov, Sandia National Laboratories + https://www.lammps.org/ Sandia National Laboratories Steve Plimpton, sjplimp@sandia.gov Copyright (2003) Sandia Corporation. Under the terms of Contract @@ -46,19 +46,15 @@ enum{LINEAR}; /* ---------------------------------------------------------------------- */ -Pair3BTable::Pair3BTable(LAMMPS *lmp) : Pair(lmp) +Pair3BTable::Pair3BTable(LAMMPS *lmp) : Pair(lmp), params(nullptr), neighshort(nullptr) { single_enable = 0; restartinfo = 0; one_coeff = 1; manybody_flag = 1; centroidstressflag = CENTROID_NOTAVAIL; - unit_convert_flag = utils::get_supported_conversions(utils::ENERGY); - - params = nullptr; maxshort = 10; - neighshort = nullptr; } /* ---------------------------------------------------------------------- @@ -85,9 +81,9 @@ Pair3BTable::~Pair3BTable() void Pair3BTable::compute(int eflag, int vflag) { int i,j,k,ii,jj,kk,inum,jnum,jnumm1; - int itype,jtype,ktype,ijparam,ikparam,ijkparam; + int itype,jtype,ktype,ijparam,ijkparam; tagint itag,jtag; - double xtmp,ytmp,ztmp,delx,dely,delz,evdwl,fpair; + double xtmp,ytmp,ztmp,delx,dely,delz,evdwl; double rsq,rsq1,rsq2; double delr1[3],delr2[3],fi[3],fj[3],fk[3]; int *ilist,*jlist,*numneigh,**firstneigh; @@ -99,8 +95,6 @@ void Pair3BTable::compute(int eflag, int vflag) double **f = atom->f; tagint *tag = atom->tag; int *type = atom->type; - int nlocal = atom->nlocal; - int newton_pair = force->newton_pair; inum = list->inum; ilist = list->ilist; @@ -178,7 +172,6 @@ void Pair3BTable::compute(int eflag, int vflag) for (kk = jj+1; kk < numshort; kk++) { k = neighshort[kk]; ktype = map[type[k]]; - ikparam = elem3param[itype][ktype][ktype]; ijkparam = elem3param[itype][jtype][ktype]; delr2[0] = x[k][0] - xtmp; @@ -186,8 +179,7 @@ void Pair3BTable::compute(int eflag, int vflag) delr2[2] = x[k][2] - ztmp; rsq2 = delr2[0]*delr2[0] + delr2[1]*delr2[1] + delr2[2]*delr2[2]; - threebody(¶ms[ijparam],¶ms[ikparam],¶ms[ijkparam], - rsq1,rsq2,delr1,delr2,fi,fj,fk,eflag,evdwl); + threebody(¶ms[ijkparam],rsq1,rsq2,delr1,delr2,fi,fj,fk,eflag,evdwl); fxtmp += fi[0]; fytmp += fi[1]; @@ -230,9 +222,8 @@ void Pair3BTable::allocate() global settings ------------------------------------------------------------------------- */ -void Pair3BTable::settings(int narg, char **arg) +void Pair3BTable::settings(int narg, char ** /*arg*/) { - //one mre additional argument: number of table entries if (narg != 0) error->all(FLERR,"Illegal pair_style command"); } @@ -290,15 +281,9 @@ void Pair3BTable::read_file(char *file) // open file on proc 0 if (comm->me == 0) { - PotentialFileReader reader(lmp, file, "3b", unit_convert_flag); + PotentialFileReader reader(lmp, file, "3b/table", unit_convert_flag); char *line; - // transparently convert units for supported conversions - - int unit_convert = reader.get_unit_convert(); - double conversion_factor = utils::get_conversion_factor(utils::ENERGY, - unit_convert); - while ((line = reader.next_line(NPARAMS_PER_LINE))) { try { ValueTokenizer values(line); @@ -348,22 +333,22 @@ void Pair3BTable::read_file(char *file) std::string tablename_string = values.next_string(); params[nparams].tablenamelength = tablename_string.length()+1; memory->create(params[nparams].tablename, params[nparams].tablenamelength, "params.tablename"); - for (int x = 0; x < params[nparams].tablenamelength; ++x) { + for (int x = 0; x < params[nparams].tablenamelength; ++x) { params[nparams].tablename[x] = tablename_string[x]; } std::string keyword_string = values.next_string(); params[nparams].keywordlength = keyword_string.length()+1; memory->create(params[nparams].keyword, params[nparams].keywordlength, "params.keyword"); - for (int x = 0; x < params[nparams].keywordlength; ++x) { + for (int x = 0; x < params[nparams].keywordlength; ++x) { params[nparams].keyword[x] = keyword_string[x]; } std::string tablestyle_string = values.next_string(); char *tablestyle; memory->create(tablestyle, (tablestyle_string.length()+1), "tablestyle"); - for (int x = 0; x < (tablestyle_string.length()+1); ++x) { + for (int x = 0; x < ((int)tablestyle_string.length()+1); ++x) { tablestyle[x] = tablestyle_string[x]; - } - if (strcmp(tablestyle,"linear") == 0) params[nparams].tabstyle = LINEAR; + } + if (strcmp(tablestyle,"linear") == 0) params[nparams].tabstyle = LINEAR; else error->all(FLERR,"Unknown table style in 3b table"); params[nparams].tablength = values.next_int(); @@ -406,7 +391,7 @@ void Pair3BTable::read_file(char *file) if (comm->me == 0){ read_table(params[m].mltable,params[m].tablename,params[m].keyword,params[m].symmetric); } - + // broadcast read in 3btable to all processes bcast_table(params[m].mltable,params[m].symmetric); @@ -484,7 +469,7 @@ void Pair3BTable::read_table(Table *tb, char *file, char *keyword, bool symmetri line = reader.next_line(); param_extract(tb, line); - + // if it is a symmetric 3body interaction, less table entries are required if (symmetric == true){ memory->create(tb->r12file,tb->ninput*tb->ninput*(tb->ninput+1),"mltable:r12file"); @@ -721,7 +706,8 @@ void Pair3BTable::null_table(Table *tb) calculate potential u and force f at angle x ------------------------------------------------------------------------- */ -void Pair3BTable::uf_lookup(Param *pm, double r12, double r13, double theta, double &f11, double &f12, double &f21, double &f22, double &f31, double &f32, double &u) +void Pair3BTable::uf_lookup(Param *pm, double r12, double r13, double theta, double &f11, double &f12, + double &f21, double &f22, double &f31, double &f32, double &u) { int i,itable,nr12,nr13,ntheta; double dr,dtheta; @@ -780,15 +766,13 @@ void Pair3BTable::uf_lookup(Param *pm, double r12, double r13, double theta, dou f22=pm->mltable->f22file[itable]; f31=pm->mltable->f31file[itable]; f32=pm->mltable->f32file[itable]; - } + } } /* ---------------------------------------------------------------------- */ -void Pair3BTable::threebody(Param *paramij, Param *paramik, Param *paramijk, - double rsq1, double rsq2, - double *delr1, double *delr2, - double *fi, double *fj, double *fk, int eflag, double &eng) +void Pair3BTable::threebody(Param *paramijk, double rsq1, double rsq2, double *delr1, double *delr2, + double *fi, double *fj, double *fk, int eflag, double &eng) { double r12,r13,theta,rinv,cs; @@ -807,7 +791,7 @@ void Pair3BTable::threebody(Param *paramij, Param *paramik, Param *paramijk, //compute angle between r12 and r13 in degrees theta = acos(cs)*180.0/MY_PI; - //if r12 > r13 swap them, as in lookup table always r13 > r12 do to symmetry reasons + //if r12 > r13 swap them, as in lookup table always r13 > r12 do to symmetry reasons if (r12 > r13){ temp = r12; r12 = r13; @@ -818,15 +802,17 @@ void Pair3BTable::threebody(Param *paramij, Param *paramik, Param *paramijk, //look up forces and energy in table belonging to parameter set paramijk //only do lookup and add three-body interactions if r12 and r13 are both between rmin and rmax - - if ( (r12 >= (paramijk->mltable->rmin - 0.5*dr)) && (r13 <= (paramijk->mltable->rmax + 0.5*dr)) && (r13 >= (paramijk->mltable->rmin - 0.5*dr)) && (r13 <= (paramijk->mltable->rmax + 0.5*dr)) ){ + + if ((r12 >= (paramijk->mltable->rmin - 0.5*dr)) && + (r13 <= (paramijk->mltable->rmax + 0.5*dr)) && + (r13 >= (paramijk->mltable->rmin - 0.5*dr)) && + (r13 <= (paramijk->mltable->rmax + 0.5*dr)) ){ uf_lookup(paramijk, r12, r13, theta, f11, f12, f21, f22, f31, f32, u); - } - else{ + } else{ f11 = f12 = f21 = f22 = f31 = f32 = u = 0.0; } - // if the indices have been swapped, swap tehm back + // if the indices have been swapped, swap them back if (swapped == true){ temp = r12; r12 = r13; @@ -854,8 +840,5 @@ void Pair3BTable::threebody(Param *paramij, Param *paramik, Param *paramijk, fk[1] = delr2[1]*f31+(delr2[1]-delr1[1])*f32; fk[2] = delr2[2]*f31+(delr2[2]-delr1[2])*f32; - double epsilon = 0.5; - double epsilon2 = epsilon*epsilon; - if (eflag) eng = u; } diff --git a/src/MANYBODY/pair_3b_table.h b/src/MANYBODY/pair_3b_table.h index a864a9602c..a250fe1b2a 100644 --- a/src/MANYBODY/pair_3b_table.h +++ b/src/MANYBODY/pair_3b_table.h @@ -1,6 +1,6 @@ /* -*- c++ -*- ---------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator - http://lammps.sandia.gov, Sandia National Laboratories + https://www.lammps.org/ Sandia National Laboratories Steve Plimpton, sjplimp@sandia.gov Copyright (2003) Sandia Corporation. Under the terms of Contract @@ -12,9 +12,9 @@ ------------------------------------------------------------------------- */ #ifdef PAIR_CLASS - -PairStyle(3b/table,Pair3BTable) - +// clang-format off +PairStyle(3b/table,Pair3BTable); +// clang-format on #else #ifndef LMP_PAIR_3B_TABLE_H @@ -40,34 +40,35 @@ class Pair3BTable : public Pair { // struct for 3b/table struct Table { int ninput; - double rmin,rmax; - double *r12file,*r13file,*thetafile,*f11file,*f12file,*f21file,*f22file,*f31file,*f32file,*efile; + double rmin, rmax; + double *r12file, *r13file, *thetafile, *f11file, *f12file, *f21file, *f22file, *f31file, + *f32file, *efile; }; struct Param { - double cut,cutsq; - int ielement,jelement,kelement; - bool symmetric; // whether it is a symmetric table or not - int tablenamelength; // length of table name - char *tablename; // name of associated angular table - int keywordlength; // length of key in table - char *keyword; // key in table - int tabstyle,tablength; // length of interpolation table (not ninput) and style - Table *mltable; // 3b Table + double cut, cutsq; + int ielement, jelement, kelement; + bool symmetric; // whether it is a symmetric table or not + int tablenamelength; // length of table name + char *tablename; // name of associated angular table + int keywordlength; // length of key in table + char *keyword; // key in table + int tabstyle, tablength; // length of interpolation table (not ninput) and style + Table *mltable; // 3b Table }; protected: - double cutmax; // max cutoff for all elements - Param *params; // parameter set for an I-J-K interaction - int maxshort; // size of short neighbor list array - int *neighshort; // short neighbor list array + double cutmax; // max cutoff for all elements + Param *params; // parameter set for an I-J-K interaction + int maxshort; // size of short neighbor list array + int *neighshort; // short neighbor list array void settings(int, char **) override; virtual void allocate(); void read_file(char *); virtual void setup_params(); - void threebody(Param *, Param *, Param *, double, double, double *, double *, - double *, double *, double *, int, double &); + void threebody(Param *, double, double, double *, double *, double *, double *, double *, int, + double &); void read_table(Table *, char *, char *, bool); void bcast_table(Table *, bool); @@ -78,61 +79,11 @@ class Pair3BTable : public Pair { void param_extract(Table *, char *); - void uf_lookup(Param *, double, double, double, double &, double &, double &, double &, double &, double &, double &); + void uf_lookup(Param *, double, double, double, double &, double &, double &, double &, double &, + double &, double &); }; -} - +} // namespace LAMMPS_NS #endif #endif - -/* ERROR/WARNING messages: - -E: Illegal ... command - -Self-explanatory. Check the input script syntax and compare to the -documentation for the command. You can use -echo screen as a -command-line option when running LAMMPS to see the offending line. - -E: Incorrect args for pair coefficients - -Self-explanatory. Check the input script or data file. - -E: Pair style 3b/table requires atom IDs - -This is a requirement to use the 3b/table potential. - -E: Pair style 3b/table requires newton pair on - -See the newton command. This is a restriction to use the 3b/table -potential. - -E: All pair coeffs are not set - -All pair coefficients must be set in the data file or by the -pair_coeff command before running a simulation. - -E: Cannot open 3b/table potential file %s - -The specified 3b/table potential file cannot be opened. Check that the path -and name are correct. - -E: Incorrect format in 3b/table potential file - -Incorrect number of words per line in the potential file. - -E: Illegal 3b/table parameter - -One or more of the coefficients defined in the potential file is -invalid. - -E: Potential file has duplicate entry - -The potential file has more than one entry for the same element. - -E: Potential file is missing an entry - -The potential file does not have a needed entry. - -*/ diff --git a/src/MANYBODY/pair_sw_3b_table.cpp b/src/MANYBODY/pair_sw_3b_table.cpp index d9ef723123..1eac9d87a7 100644 --- a/src/MANYBODY/pair_sw_3b_table.cpp +++ b/src/MANYBODY/pair_sw_3b_table.cpp @@ -33,7 +33,6 @@ #include #include - using namespace LAMMPS_NS; using MathConst::DEG2RAD; @@ -44,25 +43,13 @@ using MathConst::RAD2DEG; enum { LINEAR, SPLINE }; -#define SMALL 0.001 -#define TINY 1.E-10 +static constexpr double TINY = 1.0e-10; /* ---------------------------------------------------------------------- */ -PairSW3BTable::PairSW3BTable(LAMMPS *lmp) : PairSW(lmp) +PairSW3BTable::PairSW3BTable(LAMMPS *lmp) : PairSW(lmp), table_params(nullptr) { - single_enable = 0; - restartinfo = 0; - one_coeff = 1; - manybody_flag = 1; - centroidstressflag = CENTROID_NOTAVAIL; - unit_convert_flag = utils::get_supported_conversions(utils::ENERGY); - - params = nullptr; - extended_params = nullptr; - - maxshort = 10; - neighshort = nullptr; + unit_convert_flag = utils::NOCONVERT; } /* ---------------------------------------------------------------------- @@ -73,9 +60,9 @@ PairSW3BTable::~PairSW3BTable() { if (copymode) return; - for (int m = 0; m < nparams; m++) free_param(&extended_params[m]); // free_param will call free_table + for (int m = 0; m < nparams; m++) free_param(&table_params[m]); // free_param will call free_table memory->destroy(params); - memory->destroy(extended_params); + memory->destroy(table_params); memory->destroy(elem3param); if (allocated) { @@ -201,8 +188,8 @@ void PairSW3BTable::compute(int eflag, int vflag) delr2[2] = x[k][2] - ztmp; rsq2 = delr2[0]*delr2[0] + delr2[1]*delr2[1] + delr2[2]*delr2[2]; - threebody(¶ms[ijparam],¶ms[ikparam],¶ms[ijkparam], &extended_params[ijkparam], - rsq1,rsq2,delr1,delr2,fj,fk,eflag,evdwl); + threebody_table(¶ms[ijparam],¶ms[ikparam],&table_params[ijkparam], + rsq1,rsq2,delr1,delr2,fj,fk,eflag,evdwl); fxtmp -= fj[0] + fk[0]; fytmp -= fj[1] + fk[1]; @@ -234,22 +221,16 @@ void PairSW3BTable::read_file(char *file) { memory->sfree(params); params = nullptr; - memory->sfree(extended_params); - extended_params = nullptr; + memory->sfree(table_params); + table_params = nullptr; nparams = maxparam = 0; // open file on proc 0 if (comm->me == 0) { - PotentialFileReader reader(lmp, file, "sw", unit_convert_flag); + PotentialFileReader reader(lmp, file, "sw/3b", unit_convert_flag); char *line; - // transparently convert units for supported conversions - - int unit_convert = reader.get_unit_convert(); - double conversion_factor = utils::get_conversion_factor(utils::ENERGY, - unit_convert); - while ((line = reader.next_line(NPARAMS_PER_LINE))) { try { ValueTokenizer values(line); @@ -279,8 +260,8 @@ void PairSW3BTable::read_file(char *file) maxparam += DELTA; params = (Param *) memory->srealloc(params,maxparam*sizeof(Param), "pair:params"); - extended_params = (Param_Extension *) memory->srealloc(extended_params,maxparam*sizeof(Param_Extension), - "pair:extended_params"); + table_params = (ParamTable *) memory->srealloc(table_params,maxparam*sizeof(ParamTable), + "pair:table_params"); // make certain all addional allocated storage is initialized // to avoid false positives when checking with valgrind @@ -305,42 +286,38 @@ void PairSW3BTable::read_file(char *file) // read parameters of angle table std::string tablename_string = values.next_string(); - extended_params[nparams].tablenamelength = tablename_string.length()+1; - memory->create(extended_params[nparams].tablename, extended_params[nparams].tablenamelength, "extended_params.tablename"); - for (int x = 0; x < extended_params[nparams].tablenamelength; ++x) { - extended_params[nparams].tablename[x] = tablename_string[x]; + table_params[nparams].tablenamelength = tablename_string.length()+1; + memory->create(table_params[nparams].tablename, table_params[nparams].tablenamelength, "table_params.tablename"); + for (int i = 0; i < table_params[nparams].tablenamelength; ++i) { + table_params[nparams].tablename[i] = tablename_string[i]; } std::string keyword_string = values.next_string(); - extended_params[nparams].keywordlength = keyword_string.length()+1; - memory->create(extended_params[nparams].keyword, extended_params[nparams].keywordlength, "extended_params.keyword"); - for (int x = 0; x < extended_params[nparams].keywordlength; ++x) { - extended_params[nparams].keyword[x] = keyword_string[x]; + table_params[nparams].keywordlength = keyword_string.length()+1; + memory->create(table_params[nparams].keyword, table_params[nparams].keywordlength, "table_params.keyword"); + for (int i = 0; i < table_params[nparams].keywordlength; ++i) { + table_params[nparams].keyword[i] = keyword_string[i]; } std::string tablestyle_string = values.next_string(); char *tablestyle; memory->create(tablestyle, (tablestyle_string.length()+1), "tablestyle"); - for (int x = 0; x < (tablestyle_string.length()+1); ++x) { - tablestyle[x] = tablestyle_string[x]; - } - if (strcmp(tablestyle,"linear") == 0) extended_params[nparams].tabstyle = LINEAR; - else if (strcmp(tablestyle,"spline") == 0) extended_params[nparams].tabstyle = SPLINE; + for (int i = 0; i < ((int)tablestyle_string.length()+1); ++i) { + tablestyle[i] = tablestyle_string[i]; + } + if (strcmp(tablestyle,"linear") == 0) table_params[nparams].tabstyle = LINEAR; + else if (strcmp(tablestyle,"spline") == 0) table_params[nparams].tabstyle = SPLINE; else error->all(FLERR,"Unknown table style of angle table file"); - extended_params[nparams].tablength = values.next_int(); + table_params[nparams].tablength = values.next_int(); } catch (TokenizerException &e) { error->one(FLERR, e.what()); } - if (unit_convert) { - params[nparams].epsilon *= conversion_factor; - } - if (params[nparams].epsilon < 0.0 || params[nparams].sigma < 0.0 || params[nparams].littlea < 0.0 || params[nparams].lambda < 0.0 || params[nparams].gamma < 0.0 || params[nparams].biga < 0.0 || params[nparams].bigb < 0.0 || params[nparams].powerp < 0.0 || params[nparams].powerq < 0.0 || params[nparams].tol < 0.0 || - extended_params[nparams].tabstyle < 0.0 || extended_params[nparams].tablength < 0.0) + table_params[nparams].tabstyle < 0.0 || table_params[nparams].tablength < 0.0) error->one(FLERR,"Illegal Stillinger-Weber parameter"); nparams++; @@ -352,64 +329,63 @@ void PairSW3BTable::read_file(char *file) if (comm->me != 0) { params = (Param *) memory->srealloc(params,maxparam*sizeof(Param), "pair:params"); - extended_params = (Param_Extension *) memory->srealloc(extended_params,maxparam*sizeof(Param_Extension), "pair:extended_params"); + table_params = (ParamTable *) memory->srealloc(table_params,maxparam*sizeof(ParamTable), "pair:table_params"); } MPI_Bcast(params, maxparam*sizeof(Param), MPI_BYTE, 0, world); - MPI_Bcast(extended_params, maxparam*sizeof(Param_Extension), MPI_BYTE, 0, world); + MPI_Bcast(table_params, maxparam*sizeof(ParamTable), MPI_BYTE, 0, world); // for each set of parameters, broadcast table name and keyword and read angle table for (int m = 0; m < nparams; ++m){ if (comm->me != 0) { - memory->create(extended_params[m].tablename, extended_params[m].tablenamelength, "extended_params.tablename"); + memory->create(table_params[m].tablename, table_params[m].tablenamelength, "table_params.tablename"); } - MPI_Bcast(&extended_params[m].tablename, extended_params[m].tablenamelength, MPI_CHAR, 0, world); + MPI_Bcast(&table_params[m].tablename, table_params[m].tablenamelength, MPI_CHAR, 0, world); if (comm->me != 0) { - memory->create(extended_params[m].keyword, extended_params[m].keywordlength, "extended_params.keyword"); + memory->create(table_params[m].keyword, table_params[m].keywordlength, "table_params.keyword"); } - MPI_Bcast(&extended_params[m].keyword, extended_params[m].keywordlength, MPI_CHAR, 0, world); + MPI_Bcast(&table_params[m].keyword, table_params[m].keywordlength, MPI_CHAR, 0, world); // initialize angtable - memory->create(extended_params[m].angtable,1,"extended_params:angtable"); - null_table(extended_params[m].angtable); + memory->create(table_params[m].angtable,1,"table_params:angtable"); + null_table(table_params[m].angtable); // call read_table to read corresponding tabulated angle file (only called by process 0) - if (comm->me == 0) read_table(extended_params[m].angtable,extended_params[m].tablename,extended_params[m].keyword); + if (comm->me == 0) read_table(table_params[m].angtable,table_params[m].tablename,table_params[m].keyword); // broadcast read in angtable to all processes - bcast_table(extended_params[m].angtable); + bcast_table(table_params[m].angtable); // the following table manipulations are done in all processes // error check on table parameters - if (extended_params[m].angtable->ninput <= 1) error->one(FLERR,"Invalid angle table length"); + if (table_params[m].angtable->ninput <= 1) error->one(FLERR,"Invalid angle table length"); // error check on parameter range of angle table double alo,ahi; - alo = extended_params[m].angtable->afile[0]; - ahi = extended_params[m].angtable->afile[extended_params[m].angtable->ninput-1]; + alo = table_params[m].angtable->afile[0]; + ahi = table_params[m].angtable->afile[table_params[m].angtable->ninput-1]; if (fabs(alo-0.0) > TINY || fabs(ahi-180.0) > TINY) error->all(FLERR,"Angle table must range from 0 to 180 degrees"); // convert theta from degrees to radians - for (int i = 0; i < extended_params[m].angtable->ninput; ++i){ - extended_params[m].angtable->afile[i] *= MY_PI/180.0; - extended_params[m].angtable->ffile[i] *= 180.0/MY_PI; + for (int i = 0; i < table_params[m].angtable->ninput; ++i){ + table_params[m].angtable->afile[i] *= MY_PI/180.0; + table_params[m].angtable->ffile[i] *= 180.0/MY_PI; } // spline read-in table and compute a,e,f vectors within table - spline_table(extended_params[m].angtable); + spline_table(table_params[m].angtable); // compute_table needs parameter params[m].length for this specific interaction as - // read in value length from .sw file can be different from value in angle table file - compute_table(extended_params[m].angtable,extended_params[m].tablength); + // read in value length from .sw file can be different from value in angle table file + compute_table(table_params[m].angtable,table_params[m].tablength); } } /* ---------------------------------------------------------------------- */ -void PairSW3BTable::threebody(Param *paramij, Param *paramik, Param *paramijk, Param_Extension *extended_paramijk, - double rsq1, double rsq2, - double *delr1, double *delr2, - double *fj, double *fk, int eflag, double &eng) +void PairSW3BTable::threebody_table(Param *paramij, Param *paramik, ParamTable *table_paramijk, + double rsq1, double rsq2, double *delr1, double *delr2, + double *fj, double *fk, int eflag, double &eng) { double r1,rinvsq1,rainv1,gsrainv1,gsrainvsq1,expgsrainv1; double r2,rinvsq2,rainv2,gsrainv2,gsrainvsq2,expgsrainv2; @@ -440,7 +416,7 @@ void PairSW3BTable::threebody(Param *paramij, Param *paramik, Param *paramijk, P // look up energy (f(theta), ftheta) and force (df(theta)/dtheta, fprimetheta) at // angle theta (var) in angle table belonging to parameter set paramijk - uf_lookup(extended_paramijk, var, ftheta, fprimetheta); + uf_lookup(table_paramijk, var, ftheta, fprimetheta); acosprime = 1.0 / (sqrt(1 - cs*cs ) ); @@ -469,7 +445,7 @@ void PairSW3BTable::threebody(Param *paramij, Param *paramik, Param *paramijk, P void PairSW3BTable::read_table(Table *tb, char *file, char *keyword) { - TableFileReader reader(lmp, file, "angle"); + TableFileReader reader(lmp, file, "3b/table"); char *line = reader.find_section_start(keyword); @@ -642,7 +618,7 @@ void PairSW3BTable::free_table(Table *tb) /* ---------------------------------------------------------------------- */ -void PairSW3BTable::free_param(Param_Extension *pm) +void PairSW3BTable::free_param(ParamTable *pm) { // call free_table to destroy associated angle table free_table(pm->angtable); @@ -753,7 +729,7 @@ double PairSW3BTable::splint(double *xa, double *ya, double *y2a, int n, double calculate potential u and force f at angle x ------------------------------------------------------------------------- */ -void PairSW3BTable::uf_lookup(Param_Extension *pm, double x, double &u, double &f) +void PairSW3BTable::uf_lookup(ParamTable *pm, double x, double &u, double &f) { if (!std::isfinite(x)) { error->one(FLERR, "Illegal angle in angle style table"); } diff --git a/src/MANYBODY/pair_sw_3b_table.h b/src/MANYBODY/pair_sw_3b_table.h index 3f537d432c..187b815c1c 100644 --- a/src/MANYBODY/pair_sw_3b_table.h +++ b/src/MANYBODY/pair_sw_3b_table.h @@ -32,7 +32,7 @@ class PairSW3BTable : public PairSW { static constexpr int NPARAMS_PER_LINE = 18; - // use struct Table from class AngleTable + // use struct Table as in class AngleTable struct Table { int ninput, fpflag; double fplo, fphi, theta0; @@ -41,87 +41,37 @@ class PairSW3BTable : public PairSW { double delta, invdelta, deltasq6; double *ang, *e, *de, *f, *df, *e2, *f2; }; - - struct Param_Extension { - int tablenamelength; // length of table name - char *tablename; // name of associated angular table - int keywordlength; // length of key in table - char *keyword; // key in table - int tabstyle,tablength; // length of interpolation table (not ninput) and style - Table *angtable; // angle table + + struct ParamTable { + int tablenamelength; // length of table name + char *tablename; // name of associated angular table + int keywordlength; // length of key in table + char *keyword; // key in table + int tabstyle, tablength; // length of interpolation table (not ninput) and style + Table *angtable; // angle table }; - + protected: - Param_Extension *extended_params; // parameter set for an I-J-K interaction - + ParamTable *table_params; // tabulated parameter set for an I-J-K interaction + void read_file(char *) override; - void threebody(Param *, Param *, Param *, Param_Extension*, double, double, double *, double *, double *, - double *, int, double &); + void threebody_table(Param *, Param *, ParamTable *, double, double, double *, double *, + double *, double *, int, double &); void read_table(Table *, char *, char *); void spline_table(Table *); - void compute_table(Table *,int length); + void compute_table(Table *, int length); void bcast_table(Table *); void null_table(Table *); void free_table(Table *); - void free_param(Param_Extension *); + void free_param(ParamTable *); void param_extract(Table *, char *); void spline(double *, double *, int, double, double, double *); double splint(double *, double *, double *, int, double); - void uf_lookup(Param_Extension *, double, double &, double &); + void uf_lookup(ParamTable *, double, double &, double &); }; } // namespace LAMMPS_NS #endif #endif - -/* ERROR/WARNING messages: - -E: Illegal ... command - -Self-explanatory. Check the input script syntax and compare to the -documentation for the command. You can use -echo screen as a -command-line option when running LAMMPS to see the offending line. - -E: Incorrect args for pair coefficients - -Self-explanatory. Check the input script or data file. - -E: Pair style Stillinger-Weber requires atom IDs - -This is a requirement to use the SW potential. - -E: Pair style Stillinger-Weber requires newton pair on - -See the newton command. This is a restriction to use the SW -potential. - -E: All pair coeffs are not set - -All pair coefficients must be set in the data file or by the -pair_coeff command before running a simulation. - -E: Cannot open Stillinger-Weber potential file %s - -The specified SW potential file cannot be opened. Check that the path -and name are correct. - -E: Incorrect format in Stillinger-Weber potential file - -Incorrect number of words per line in the potential file. - -E: Illegal Stillinger-Weber parameter - -One or more of the coefficients defined in the potential file is -invalid. - -E: Potential file has duplicate entry - -The potential file has more than one entry for the same element. - -E: Potential file is missing an entry - -The potential file does not have a needed entry. - -*/ From d9b560e70be3a31ee4886713dabcd1442d6bc289 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 26 May 2022 12:08:21 -0400 Subject: [PATCH 223/585] properly integrate into manual --- doc/src/Commands_pair.rst | 2 + doc/src/pair_3b_table.rst | 36 +++++++-------- doc/src/pair_style.rst | 2 + doc/src/pair_sw_3b_table.rst | 50 +++++++++++---------- doc/utils/sphinx-config/false_positives.txt | 7 +++ 5 files changed, 56 insertions(+), 41 deletions(-) diff --git a/doc/src/Commands_pair.rst b/doc/src/Commands_pair.rst index c5782f5e04..21a84a2518 100644 --- a/doc/src/Commands_pair.rst +++ b/doc/src/Commands_pair.rst @@ -34,6 +34,7 @@ OPT. * * * + * :doc:`3b/table ` * :doc:`adp (ko) ` * :doc:`agni (o) ` * :doc:`airebo (io) ` @@ -269,6 +270,7 @@ OPT. * :doc:`spin/neel ` * :doc:`srp ` * :doc:`sw (giko) ` + * :doc:`sw/3b/table ` * :doc:`sw/mod (o) ` * :doc:`table (gko) ` * :doc:`table/rx (k) ` diff --git a/doc/src/pair_3b_table.rst b/doc/src/pair_3b_table.rst index ae5e6c2a50..0a239883e4 100644 --- a/doc/src/pair_3b_table.rst +++ b/doc/src/pair_3b_table.rst @@ -1,4 +1,4 @@ -.. index:: pair_style 3b_table +.. index:: pair_style 3b/table pair_style 3b/table command =========================== @@ -26,22 +26,22 @@ Examples Description """"""""""" -The *3b/table* style is a pair style for generic tabulated three-body interactions. -It has been developed for (coarse-grained) simulations (of water) -with Kernel-based machine learning (ML) potentials (:ref:`Scherer2 `). -As for the pair style :doc:`pair_style sw ` -or :doc:`pair_style sw/table `, the energy of a system -is computed as a sum over three-body terms: +The *3b/table* style is a pair style for generic tabulated three-body +interactions. It has been developed for (coarse-grained) simulations +(of water) with Kernel-based machine learning (ML) potentials +(:ref:`Scherer2 `). As for the pair style :doc:`pair_style sw +` or :doc:`pair_style sw/3b/table `, the energy of +a system is computed as a sum over three-body terms: .. math:: E = \sum_i \sum_{j \neq i} \sum_{k > j} \phi_3 (r_{ij}, r_{ik}, \theta_{ijk}) -The summations in the formula are over all neighbors J -and K of atom I within a cutoff distance :math:`cut`. -In contrast to the Stillinger-Weber potential, all forces are not calculated analytically, but -read in from a three-body force/energy table which can be generated with -the csg_ml app of VOTCA as available at: . +The summations in the formula are over all neighbors J and K of atom I +within a cutoff distance :math:`cut`. In contrast to the +Stillinger-Weber potential, all forces are not calculated analytically, +but read in from a three-body force/energy table which can be generated +with the csg_ml app of VOTCA as available at: https://gitlab.mpcdf.mpg.de/votca/votca. Only a single pair_coeff command is used with the *3b/table* style which specifies a three-body potential (".3b") file with parameters for all @@ -102,14 +102,14 @@ If element 2 and element 3 are of the same type (e.g. SiCC), the distance due to the symmetry of the triplet. If element 2 and element 3 are not of the same type (e.g. SiCSi), there is no additional symmetry and the distance :math:`r_{ik}` is also varied from rmin to rmax in "N" steps. -The angle :math:`\theta_{ijk}` is alsways varied in "2N" steps from +The angle :math:`\theta_{ijk}` is always varied in "2N" steps from (0.0 + 180.0/(4N)) to (180.0 - 180.0/(4N)). Therefore, the total number of table entries is "M = N * N * (N+1)" for the symmetric (element 2 and element 3 are of the same type) and "M = 2 * N * N * N" for the general case (element 2 and element 3 are not of the same type). The forces on all three particles I, J, and K of a triplet -of this type of thre-body interaction potential +of this type of three-body interaction potential (:math:`\phi_3 (r_{ij}, r_{ik}, \theta_{ijk})`) lie within the plane defined by the three inter-particle distance vectors :math:`{\mathbf r}_{ij}`, :math:`{\mathbf r}_{ik}`, and :math:`{\mathbf r}_{jk}`. @@ -187,13 +187,13 @@ one that matches the specified *keyword* of appropriate section of the ".3b" fil At the moment, only the *style* *linear* is allowed and implemented. After reading in the force table, it is internally stored in LAMMPS as a lookup table. For each triplet -configuration occuring in the simulation within the cutoff distance, +configuration occurring in the simulation within the cutoff distance, the next nearest tabulated triplet configuration is looked up. No interpolation is done. This allows for a very efficient force calculation with the stored force constants and energies. Due to the know table structure, the lookup can be done efficiently. It has been tested (:ref:`Scherer2 `) that with a reasonably small bin size, the accuracy and speed is comparable to that of a Stillinger-Weber potential -with tabulated three-body interactions (:doc:`pair_style sw/table `) while +with tabulated three-body interactions (:doc:`pair_style sw/table `) while the table format of this pair style allows for more flexible three-body interactions. As for the Stillinger-Weber potential, the three-body potential file must contain entries for all the @@ -254,12 +254,12 @@ in the tutorial folder. Related commands """""""""""""""" -:doc:`pair_coeff ` +:doc:`pair_coeff `, :doc:`pair sw/3b/table ` ---------- .. _Scherer2: -**(Scherer2)** C. Scherer, R. Scheid, D. Andrienko, and T. Bereau, J. Chem. Theor. Comp. 16, 3194–3204 (2020). +**(Scherer2)** C. Scherer, R. Scheid, D. Andrienko, and T. Bereau, J. Chem. Theor. Comp. 16, 3194-3204 (2020). diff --git a/doc/src/pair_style.rst b/doc/src/pair_style.rst index 2bcd66590d..d24596e2fa 100644 --- a/doc/src/pair_style.rst +++ b/doc/src/pair_style.rst @@ -112,6 +112,7 @@ accelerated styles exist. * :doc:`hybrid/scaled ` - multiple styles of scaled superposed pairwise interactions * :doc:`zero ` - neighbor list but no interactions +* :doc:`3b/table ` - generic tabulated three-body potential * :doc:`adp ` - angular dependent potential (ADP) of Mishin * :doc:`agni ` - AGNI machine-learning potential * :doc:`airebo ` - AIREBO potential of Stuart @@ -348,6 +349,7 @@ accelerated styles exist. * :doc:`spin/neel ` - * :doc:`srp ` - * :doc:`sw ` - Stillinger-Weber 3-body potential +* :doc:`sw/3b/table ` - Stillinger-Weber potential with tabulated 3-body term * :doc:`sw/mod ` - modified Stillinger-Weber 3-body potential * :doc:`table ` - tabulated pair potential * :doc:`table/rx ` - diff --git a/doc/src/pair_sw_3b_table.rst b/doc/src/pair_sw_3b_table.rst index 97fcb63e34..2d57803a61 100644 --- a/doc/src/pair_sw_3b_table.rst +++ b/doc/src/pair_sw_3b_table.rst @@ -1,4 +1,4 @@ -.. index:: pair_style sw_3b_table +.. index:: pair_style sw/3b/table pair_style sw/3b/table command ============================== @@ -26,10 +26,12 @@ Examples Description """"""""""" -The *sw/3b/table* style is a modification of the original :doc:`pair_style sw `. It has been -developed for coarse-grained simulations (of water) (:ref:`Scherer1 `), -but can be employed for all kinds of systems. It computes a modified 3-body :ref:`Stillinger-Weber ` -potential for the energy E of a system of atoms as +The *sw/3b/table* style is a modification of the original +:doc:`pair_style sw `. It has been developed for coarse-grained +simulations (of water) (:ref:`Scherer1 `), but can be employed +for all kinds of systems. It computes a modified 3-body +:ref:`Stillinger-Weber ` potential for the energy E of a +system of atoms as .. math:: @@ -48,8 +50,8 @@ three-body term. The summations in the formula are over all neighbors J and K of atom I within a cutoff distance :math:`a \sigma`. In contrast to the original *sw* style, *sw/3b/table* allows for a flexible three-body term :math:`f^{\textrm{3b}}\left(\theta_{ijk}\right)` which is read in -as a tabulated interaction. It can be parametrized with the csg_fmatch app of VOTCA -as available at: . +as a tabulated interaction. It can be parameterized with the csg_fmatch app of VOTCA +as available at: https://gitlab.mpcdf.mpg.de/votca/votca. Only a single pair_coeff command is used with the *sw/3b/table* style which specifies a modified Stillinger-Weber potential file with parameters for all @@ -191,19 +193,21 @@ are estimated (less accurately) by the first two and last two derivative values in the table. The "EQ" parameter is also optional. If used, it is followed by a the -equilibrium angle value, which is used, for example, by the :doc:`fix shake ` command. If not used, the equilibrium angle is -set to 180.0. +equilibrium angle value, which is used, for example, by the :doc:`fix +shake ` command. If not used, the equilibrium angle is set to +180.0. -Following a blank line, the next N lines of the angular table file list the tabulated values. -On each line, the first value is the index from 1 to N, the second value is -the angle value (in degrees), the third value is the energy (in energy -units), and the fourth is -dE/d(theta) (also in energy units). The third -term is the energy of the 3-atom configuration for the specified -angle. The last term is the derivative of the energy with respect to -the angle (in degrees, not radians). Thus the units of the last term -are still energy, not force. The angle values must increase from one -line to the next. The angle values must also begin with 0.0 and end -with 180.0, i.e. span the full range of possible angles. +Following a blank line, the next N lines of the angular table file list +the tabulated values. On each line, the first value is the index from 1 +to N, the second value is the angle value (in degrees), the third value +is the energy (in energy units), and the fourth is -dE/d(theta) (also in +energy units). The third term is the energy of the 3-atom configuration +for the specified angle. The last term is the derivative of the energy +with respect to the angle (in degrees, not radians). Thus the units of +the last term are still energy, not force. The angle values must +increase from one line to the next. The angle values must also begin +with 0.0 and end with 180.0, i.e. span the full range of possible +angles. Note that one angular potential file can contain many sections, each with a tabulated potential. LAMMPS reads the file section by section until it finds @@ -282,8 +286,8 @@ This pair style can only be used via the *pair* keyword of the Restrictions """""""""""" -This is a user pair style. For more information, see :ref:`Scherer1 `. It is only enabled -if LAMMPS was explicitly built with it. +This is a user pair style. For more information, see :ref:`Scherer1 +`. It is only enabled if LAMMPS was explicitly built with it. This pair style requires the :doc:`newton ` setting to be "on" for pair interactions. @@ -294,12 +298,12 @@ in the tutorial folder. Related commands """""""""""""""" -:doc:`pair_coeff ` +:doc:`pair_coeff `, :doc:`pair_style sw `, :doc:`pair_style 3b/table ` ---------- -.. _Stillinger2: +.. _Stillinger3: **(Stillinger)** Stillinger and Weber, Phys Rev B, 31, 5262 (1985). diff --git a/doc/utils/sphinx-config/false_positives.txt b/doc/utils/sphinx-config/false_positives.txt index c8450c570b..083d25bd2f 100644 --- a/doc/utils/sphinx-config/false_positives.txt +++ b/doc/utils/sphinx-config/false_positives.txt @@ -94,6 +94,7 @@ amu Amzallag analytical Anders +Andrienko Andzelm Ang anglegrad @@ -239,6 +240,7 @@ benchmarking Bennet Berardi Beraun +Bereau berendsen Berendsen berger @@ -560,6 +562,7 @@ Crozier Cryst Crystallogr Csanyi +csg csh cshrc CSiC @@ -873,6 +876,7 @@ Eindhoven Eisenforschung Ejtehadi El +el elaplong elastance Electroneg @@ -1081,6 +1085,7 @@ fm fmackay fmag fmass +fmatch fmm fmt fmtlib @@ -2405,6 +2410,7 @@ Nstep Nsteplast Nstop nsub +Nsw Nswap nt Nt @@ -3034,6 +3040,7 @@ scalexz scaleyz Scalfi Schaik +Scheid Schilfgarde Schimansky Schiotz From f0f6660050cd6929374272d427af052c7503a16c Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 26 May 2022 12:15:27 -0400 Subject: [PATCH 224/585] join lines --- src/read_data.cpp | 9 +++------ 1 file changed, 3 insertions(+), 6 deletions(-) diff --git a/src/read_data.cpp b/src/read_data.cpp index b77394bcb3..bc19a7f2ad 100644 --- a/src/read_data.cpp +++ b/src/read_data.cpp @@ -313,11 +313,9 @@ void ReadData::command(int narg, char **arg) error->all(FLERR,"Reading a data file with shrinkwrap boundaries is " "not compatible with a MSM KSpace style"); if (domain->box_exist && !addflag) - error->all(FLERR,"Cannot read_data without add keyword " - "after simulation box is defined"); + error->all(FLERR,"Cannot read_data without add keyword after simulation box is defined"); if (!domain->box_exist && addflag) - error->all(FLERR,"Cannot use read_data add before " - "simulation box is defined"); + error->all(FLERR,"Cannot use read_data add before simulation box is defined"); if (offsetflag && addflag == NONE) error->all(FLERR,"Cannot use read_data offset without add flag"); if (shiftflag && addflag == NONE) @@ -330,8 +328,7 @@ void ReadData::command(int narg, char **arg) // check if data file is available and readable if (!platform::file_is_readable(arg[0])) - error->all(FLERR,fmt::format("Cannot open file {}: {}", - arg[0], utils::getsyserror())); + error->all(FLERR,fmt::format("Cannot open file {}: {}", arg[0], utils::getsyserror())); // reset so we can warn about reset image flags exactly once per data file From 587999fabb6286142c6d8a90d060a2bd1a1f770c Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 26 May 2022 15:33:23 -0400 Subject: [PATCH 225/585] mention that MSM does not support shrink-wrap --- doc/src/kspace_style.rst | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/doc/src/kspace_style.rst b/doc/src/kspace_style.rst index b2b4157247..59efbdc5bd 100644 --- a/doc/src/kspace_style.rst +++ b/doc/src/kspace_style.rst @@ -475,8 +475,8 @@ that package **and** the KSPACE package. See the :doc:`Build package ` page for more info. For MSM, a simulation must be 3d and one can use any combination of -periodic, non-periodic, or shrink-wrapped boundaries (specified using -the :doc:`boundary ` command). +periodic, non-periodic, but not shrink-wrapped boundaries (specified +using the :doc:`boundary ` command). For Ewald and PPPM, a simulation must be 3d and periodic in all dimensions. The only exception is if the slab option is set with From f09e4c7583dca6dc3905dd57e103e6efed3b7dd6 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 26 May 2022 16:56:43 -0400 Subject: [PATCH 226/585] remove check on box size from pair style bop --- src/MANYBODY/pair_bop.cpp | 5 ----- 1 file changed, 5 deletions(-) diff --git a/src/MANYBODY/pair_bop.cpp b/src/MANYBODY/pair_bop.cpp index b3aa470592..10e423f2d2 100644 --- a/src/MANYBODY/pair_bop.cpp +++ b/src/MANYBODY/pair_bop.cpp @@ -189,11 +189,6 @@ PairBOP::~PairBOP() void PairBOP::compute(int eflag, int vflag) { - double minbox = MIN(MIN(domain->xprd, domain->yprd), domain->zprd); - if (minbox-0.001 < 6.0*cutmax) - error->all(FLERR,"Pair style bop requires system dimension " - "of at least {:.4}",6.0*cutmax); - int i, ii, j, jj; int nlisti, *ilist; tagint i_tag,j_tag, itype, jtype; From 49a75d576ebdaafa1c34d3c2a56549dc5f78b513 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Thu, 26 May 2022 17:28:05 -0600 Subject: [PATCH 227/585] Eliminated bad torsion forces when when sin(theta) is zero --- src/REAXFF/reaxff_torsion_angles.cpp | 15 +++++++-------- 1 file changed, 7 insertions(+), 8 deletions(-) diff --git a/src/REAXFF/reaxff_torsion_angles.cpp b/src/REAXFF/reaxff_torsion_angles.cpp index 329f7b8a7a..4bf810b431 100644 --- a/src/REAXFF/reaxff_torsion_angles.cpp +++ b/src/REAXFF/reaxff_torsion_angles.cpp @@ -52,6 +52,11 @@ namespace ReaxFF { sin_jkl = sin(p_jkl->theta); cos_jkl = cos(p_jkl->theta); + if (sin_ijk >= 0 && sin_ijk <= MIN_SINE) sin_ijk = MIN_SINE; + else if (sin_ijk <= 0 && sin_ijk >= -MIN_SINE) sin_ijk = -MIN_SINE; + if (sin_jkl >= 0 && sin_jkl <= MIN_SINE) sin_jkl = MIN_SINE; + else if (sin_jkl <= 0 && sin_jkl >= -MIN_SINE) sin_jkl = -MIN_SINE; + /* omega */ unnorm_cos_omega = -rvec_Dot(dvec_ij, dvec_jk) * rvec_Dot(dvec_jk, dvec_kl) + SQR(r_jk) * rvec_Dot(dvec_ij, dvec_kl); @@ -71,22 +76,16 @@ namespace ReaxFF { hnhd = r_ij * r_kl * cos_ijk * sin_jkl; hnhe = r_ij * r_kl * sin_ijk * cos_jkl; - poem = 2.0 * r_ij * r_kl * sin_ijk * sin_jkl; - if (poem < 1e-20) poem = 1e-20; - tel = SQR(r_ij) + SQR(r_jk) + SQR(r_kl) - SQR(r_li) - 2.0 * (r_ij * r_jk * cos_ijk - r_ij * r_kl * cos_ijk * cos_jkl + r_jk * r_kl * cos_jkl); + poem = 2.0 * r_ij * r_kl * sin_ijk * sin_jkl; + arg = tel / poem; if (arg > 1.0) arg = 1.0; if (arg < -1.0) arg = -1.0; - if (sin_ijk >= 0 && sin_ijk <= MIN_SINE) sin_ijk = MIN_SINE; - else if (sin_ijk <= 0 && sin_ijk >= -MIN_SINE) sin_ijk = -MIN_SINE; - if (sin_jkl >= 0 && sin_jkl <= MIN_SINE) sin_jkl = MIN_SINE; - else if (sin_jkl <= 0 && sin_jkl >= -MIN_SINE) sin_jkl = -MIN_SINE; - // dcos_omega_di rvec_ScaledSum(dcos_omega_di, (htra-arg*hnra)/r_ij, dvec_ij, -1., dvec_li); rvec_ScaledAdd(dcos_omega_di,-(hthd-arg*hnhd)/sin_ijk, p_ijk->dcos_dk); From 3ecb6bb54af747034da79c865492b415480537a5 Mon Sep 17 00:00:00 2001 From: Christoph Scherer Date: Fri, 27 May 2022 12:34:53 +0200 Subject: [PATCH 228/585] Update pair_3b_table.cpp Added (forgotten) line "u=pm->mltable->efile[itable];" to compute energy due to read in table values --- src/MANYBODY/pair_3b_table.cpp | 1 + 1 file changed, 1 insertion(+) diff --git a/src/MANYBODY/pair_3b_table.cpp b/src/MANYBODY/pair_3b_table.cpp index fd91713af8..6e908d6816 100644 --- a/src/MANYBODY/pair_3b_table.cpp +++ b/src/MANYBODY/pair_3b_table.cpp @@ -766,6 +766,7 @@ void Pair3BTable::uf_lookup(Param *pm, double r12, double r13, double theta, dou f22=pm->mltable->f22file[itable]; f31=pm->mltable->f31file[itable]; f32=pm->mltable->f32file[itable]; + u=pm->mltable->efile[itable]; } } From cfb3d6bdf87faa3f3eeaf1dbf79be8aa5c1aa771 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 27 May 2022 07:48:00 -0400 Subject: [PATCH 229/585] simplify, remove inactive code, plug memory leaks --- src/MANYBODY/pair_3b_table.cpp | 111 ++++++++++++++---------------- src/MANYBODY/pair_sw_3b_table.cpp | 15 ++-- 2 files changed, 56 insertions(+), 70 deletions(-) diff --git a/src/MANYBODY/pair_3b_table.cpp b/src/MANYBODY/pair_3b_table.cpp index 6e908d6816..00af61ee82 100644 --- a/src/MANYBODY/pair_3b_table.cpp +++ b/src/MANYBODY/pair_3b_table.cpp @@ -39,11 +39,6 @@ using MathConst::MY_PI; #define DELTA 4 -enum{LINEAR}; - -#define SMALL 0.001 -#define TINY 1.E-10 - /* ---------------------------------------------------------------------- */ Pair3BTable::Pair3BTable(LAMMPS *lmp) : Pair(lmp), params(nullptr), neighshort(nullptr) @@ -342,14 +337,9 @@ void Pair3BTable::read_file(char *file) for (int x = 0; x < params[nparams].keywordlength; ++x) { params[nparams].keyword[x] = keyword_string[x]; } - std::string tablestyle_string = values.next_string(); - char *tablestyle; - memory->create(tablestyle, (tablestyle_string.length()+1), "tablestyle"); - for (int x = 0; x < ((int)tablestyle_string.length()+1); ++x) { - tablestyle[x] = tablestyle_string[x]; - } - if (strcmp(tablestyle,"linear") == 0) params[nparams].tabstyle = LINEAR; - else error->all(FLERR,"Unknown table style in 3b table"); + auto tablestyle = values.next_string(); + if (tablestyle != "linear") + error->all(FLERR,"Unknown table style {} in 3b table", tablestyle); params[nparams].tablength = values.next_int(); } catch (TokenizerException &e) { @@ -672,6 +662,8 @@ void Pair3BTable::free_param(Param *pm) // call free_table to destroy associated 3btable free_table(pm->mltable); // then destroy associated 3btable + memory->sfree(pm->tablename); + memory->sfree(pm->keyword); memory->sfree(pm->mltable); } @@ -716,58 +708,55 @@ void Pair3BTable::uf_lookup(Param *pm, double r12, double r13, double theta, dou //lookup scheme - if (pm->tabstyle == LINEAR) { - // if it is a symmetric 3body interaction, less table entries are required - if (pm->symmetric == true){ - nr12 = (r12 - pm->mltable->rmin + 0.5*dr - 0.00000001)/dr; - if (r12 == (pm->mltable->rmin - 0.5*dr)){ - nr12 = 0; - } - nr13 = (r13 - pm->mltable->rmin + 0.5*dr - 0.00000001)/dr; - if (r13 == (pm->mltable->rmin - 0.5*dr)){ - nr13 = 0; - } - nr13 -= nr12; - ntheta = (theta-0.00000001)/dtheta; - if (theta == 180.0){ - ntheta = 79; - } - itable = 0; - for (i=0; imltable->ninput-i); - } - itable += nr13; - itable *= (pm->mltable->ninput*2); - itable += ntheta; + // if it is a symmetric 3body interaction, less table entries are required + if (pm->symmetric == true){ + nr12 = (r12 - pm->mltable->rmin + 0.5*dr - 0.00000001)/dr; + if (r12 == (pm->mltable->rmin - 0.5*dr)){ + nr12 = 0; } + nr13 = (r13 - pm->mltable->rmin + 0.5*dr - 0.00000001)/dr; + if (r13 == (pm->mltable->rmin - 0.5*dr)){ + nr13 = 0; + } + nr13 -= nr12; + ntheta = (theta-0.00000001)/dtheta; + if (theta == 180.0){ + ntheta = 79; + } + itable = 0; + for (i=0; imltable->ninput-i); + } + itable += nr13; + itable *= (pm->mltable->ninput*2); + itable += ntheta; + } else { // else, more (full) table entries are required - else{ - nr12 = (r12 - pm->mltable->rmin + 0.5*dr - 0.00000001)/dr; - if (r12 == (pm->mltable->rmin - 0.5*dr)){ - nr12 = 0; - } - nr13 = (r13 - pm->mltable->rmin + 0.5*dr - 0.00000001)/dr; - if (r13 == (pm->mltable->rmin - 0.5*dr)){ - nr13 = 0; - } - ntheta = (theta-0.00000001)/dtheta; - if (theta == 180.0){ - ntheta = 79; - } - itable = nr12*(pm->mltable->ninput); - itable += nr13; - itable *= (pm->mltable->ninput*2); - itable += ntheta; + nr12 = (r12 - pm->mltable->rmin + 0.5*dr - 0.00000001)/dr; + if (r12 == (pm->mltable->rmin - 0.5*dr)){ + nr12 = 0; } - - f11=pm->mltable->f11file[itable]; - f12=pm->mltable->f12file[itable]; - f21=pm->mltable->f21file[itable]; - f22=pm->mltable->f22file[itable]; - f31=pm->mltable->f31file[itable]; - f32=pm->mltable->f32file[itable]; - u=pm->mltable->efile[itable]; + nr13 = (r13 - pm->mltable->rmin + 0.5*dr - 0.00000001)/dr; + if (r13 == (pm->mltable->rmin - 0.5*dr)){ + nr13 = 0; + } + ntheta = (theta-0.00000001)/dtheta; + if (theta == 180.0){ + ntheta = 79; + } + itable = nr12*(pm->mltable->ninput); + itable += nr13; + itable *= (pm->mltable->ninput*2); + itable += ntheta; } + + f11=pm->mltable->f11file[itable]; + f12=pm->mltable->f12file[itable]; + f21=pm->mltable->f21file[itable]; + f22=pm->mltable->f22file[itable]; + f31=pm->mltable->f31file[itable]; + f32=pm->mltable->f32file[itable]; + u=pm->mltable->efile[itable]; } /* ---------------------------------------------------------------------- */ diff --git a/src/MANYBODY/pair_sw_3b_table.cpp b/src/MANYBODY/pair_sw_3b_table.cpp index 1eac9d87a7..a614e428e0 100644 --- a/src/MANYBODY/pair_sw_3b_table.cpp +++ b/src/MANYBODY/pair_sw_3b_table.cpp @@ -297,15 +297,10 @@ void PairSW3BTable::read_file(char *file) for (int i = 0; i < table_params[nparams].keywordlength; ++i) { table_params[nparams].keyword[i] = keyword_string[i]; } - std::string tablestyle_string = values.next_string(); - char *tablestyle; - memory->create(tablestyle, (tablestyle_string.length()+1), "tablestyle"); - for (int i = 0; i < ((int)tablestyle_string.length()+1); ++i) { - tablestyle[i] = tablestyle_string[i]; - } - if (strcmp(tablestyle,"linear") == 0) table_params[nparams].tabstyle = LINEAR; - else if (strcmp(tablestyle,"spline") == 0) table_params[nparams].tabstyle = SPLINE; - else error->all(FLERR,"Unknown table style of angle table file"); + auto tablestyle = values.next_string(); + if (tablestyle == "linear") table_params[nparams].tabstyle = LINEAR; + else if (tablestyle == "spline") table_params[nparams].tabstyle = SPLINE; + else error->all(FLERR,"Unknown table style {} of 3b/table file", tablestyle); table_params[nparams].tablength = values.next_int(); } catch (TokenizerException &e) { @@ -623,6 +618,8 @@ void PairSW3BTable::free_param(ParamTable *pm) // call free_table to destroy associated angle table free_table(pm->angtable); // then destroy associated angle table + memory->sfree(pm->keyword); + memory->sfree(pm->tablename); memory->sfree(pm->angtable); } From d7c1e54538c9a40b150f2d457d59dc7d12b33d6e Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Fri, 27 May 2022 17:30:20 -0600 Subject: [PATCH 230/585] address some more NOTE comments --- doc/src/Howto_amoeba.rst | 9 ++--- doc/src/pair_amoeba.rst | 26 ++++++++++++-- examples/amoeba/in.ubiquitin | 4 +-- examples/amoeba/in.water_box.amoeba | 2 +- src/AMOEBA/amoeba_file.cpp | 55 +++++++++++++++++++---------- src/AMOEBA/amoeba_induce.cpp | 2 +- src/AMOEBA/pair_amoeba.cpp | 37 ++++++++++--------- 7 files changed, 89 insertions(+), 46 deletions(-) diff --git a/doc/src/Howto_amoeba.rst b/doc/src/Howto_amoeba.rst index a11696e33e..b804fb8d1a 100644 --- a/doc/src/Howto_amoeba.rst +++ b/doc/src/Howto_amoeba.rst @@ -8,7 +8,7 @@ their `Tinker MD code `_. The current implementaion (May 2022) of AMOEBA in LAMMPS matches the version discussed in :ref:`(Ponder) `, :ref:`(Ren) -`, and :ref:`(Shi) `. Likewise th current +`, and :ref:`(Shi) `. Likewise the current implementaion of HIPPO in LAMMPS matches the version discussed in :ref:`(Rackers) `. @@ -27,6 +27,10 @@ HIPPO files for a variety of small organic and biomolecules are in preparation by the Ponder group. Those force field files will be included in the LAMMPS distribution when available. +To use the AMOEBA or HIPPO force fields, a simulation must be 3d, and +fully periodic or fully non-periodic, and use an orthogonal (not +triclinic) simulation box. + ---------- The AMOEBA and HIPPO force fields contain the following terms in their @@ -293,9 +297,6 @@ For periodic systems, the -pbc switch is required. It specifies the periodic box size for each dimension (x,y,z). For a Tinker simulation these are specified in the KEY file. -NOTE: What about a system with a free surface. What about a triclinic -box. - The -bitorsion switch is only needed if the system contains Tinker bitorsion interactions. The data for each type of bitorsion interaction will be written to the specified file, and read by the diff --git a/doc/src/pair_amoeba.rst b/doc/src/pair_amoeba.rst index 5a587e9d30..1436efa267 100644 --- a/doc/src/pair_amoeba.rst +++ b/doc/src/pair_amoeba.rst @@ -6,7 +6,6 @@ pair_style amoeba command pair_style hippo command ======================== - Syntax """""" @@ -63,13 +62,13 @@ these terms: .. math:: - U_{amoeba} = U_{hal} + U_{multipole} + U_{polar} + U_{amoeba} = U_{multipole} + U_{polar} + U_{hal} while the HIPPO force field contains these terms: .. math:: - U_{hippo} = U_{repulsion} + U_{dispersion} + U_{multipole} + U_{polar} + U_{qxfer} + U_{hippo} = U_{multipole} + U_{polar} + U_{qxfer} + U_{repulsion} + U_{dispersion} Conceptually, these terms compute the following interactions: @@ -84,6 +83,27 @@ Note that the AMOEBA versus HIPPO force fields typically compute the same term differently using their own formulas. The references on this doc page give full details for both force fields. +The formulas for the AMOEBA energy terms are: + +.. math:: + + U_{hal} = \epsilon_{ij} \left( \frac{1.07}{\rho_{ij} + 0.07} \right)^7 \left( \frac{1.12}{\rho_{ij}^7 + 0.12} - 2 \right) + U_{multipole} = \vec{M_i}\bold{T_{ij}}\vec{M_j} + \vec{M} = \left( q, \vec{\mu_{perm}}, \bold{\Theta} \right) + U_{polar} = \frac{1}{2}\vec{\mu_i}^{ind} \vec{E_i}^{perm} + +The formulas for the HIPPO energy terms are: + +.. math:: + + U_{multipole} = Z_i \frac{1}{r_{ij}} Z_j + Z_i T_{ij}^{damp} \vec{M_j} + Z_j T_{ji}^{damp} \vec{M_i} + \vec{M_i} T_{ij}^{damp} \vec{M_j} + \vec{M} = \left( Q, \vec{\mu_{perm}}, \bold{\Theta} \right) + U_{polar} = \frac{1}{2}\vec{\mu_i}^{ind} \vec{E_i}^{perm} + U_{qxfer} = \epsilon_i e^{-\eta_j r_{ij}} + \epsilon_j e^{-\eta_i r_{ij}} + U_{repulsion} = \frac{K_i K_j}{r_{ij}} S^2 + S^2 = \left( \int{\phi_i \phi_j} dv \right)^2 = \vec{M_i}\bold{T_{ij}^{repulsion}}\vec{M_j} + U_{dispersion} = -\frac{C_6^iC_6^j}{r_{ij}^6} \left( f_{damp}^{dispersion} \right)_{ij}^2 + .. note:: The AMOEBA and HIPPO force fields compute long-range charge, dipole, diff --git a/examples/amoeba/in.ubiquitin b/examples/amoeba/in.ubiquitin index 859c53e17f..8fb7f766a6 100644 --- a/examples/amoeba/in.ubiquitin +++ b/examples/amoeba/in.ubiquitin @@ -52,5 +52,5 @@ dump_modify 1 sort id fix 1 all nve -thermo 1 -run 10 +thermo 10 +run 100 diff --git a/examples/amoeba/in.water_box.amoeba b/examples/amoeba/in.water_box.amoeba index ca63996264..9c46f9d5c8 100644 --- a/examples/amoeba/in.water_box.amoeba +++ b/examples/amoeba/in.water_box.amoeba @@ -1,4 +1,4 @@ -# water box with AMOEBA or HIPPO +# replicate water box with AMOEBA or HIPPO units real boundary p p p diff --git a/src/AMOEBA/amoeba_file.cpp b/src/AMOEBA/amoeba_file.cpp index 79144dc348..aad74544b0 100644 --- a/src/AMOEBA/amoeba_file.cpp +++ b/src/AMOEBA/amoeba_file.cpp @@ -51,6 +51,10 @@ enum{GEAR,ASPC,LSQR}; void PairAmoeba::set_defaults() { + optorder = 0; + maxualt = 7; + tcgnab = 0; + for (int i = 0; i <= 4; i++) { special_hal[i] = 1.0; special_repel[i] = 1.0; @@ -492,9 +496,21 @@ void PairAmoeba::read_keyfile(char *filename) if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); pcgpeek = utils::numeric(FLERR,words[1],true,lmp); - // NOTE: throw an error if keyword LAMMPS does not recognize ? + // Tinker keywords that LAMMPS can skip - } else {} + } else if (strcmp(keyword,"parameters") == 0) { + } else if (strcmp(keyword,"verbose") == 0) { + } else if (strcmp(keyword,"openmp-threads") == 0) { + } else if (strcmp(keyword,"digits") == 0) { + } else if (strcmp(keyword,"neighbor-list") == 0) { + } else if (strcmp(keyword,"tau-temperature") == 0) { + } else if (strcmp(keyword,"tau-pressure") == 0) { + + // error if LAMMPS does not recognize other keywords + + } else error->all(FLERR, + "LAMMPS does not recognize AMOEBA keyfile keyword {}", + keyword); delete [] copy; delete [] words; @@ -783,9 +799,6 @@ void PairAmoeba::file_ffield(int nwords, char **words) else if (strcmp(words[1],"direct") == 0) poltyp = DIRECT; else error->all(FLERR,"Unrecognized polarization in AMOEBA FF file"); - // NOTE: enable all variants of special settings - // do these need to be set to defaults if don't appear in file? - } else if (strcmp(words[0],"vdw-12-scale") == 0) { special_hal[1] = utils::numeric(FLERR,words[1],true,lmp); } else if (strcmp(words[0],"vdw-13-scale") == 0) { @@ -851,23 +864,29 @@ void PairAmoeba::file_ffield(int nwords, char **words) } else if (strcmp(words[0],"direct-11-scale") == 0) { polar_dscale = utils::numeric(FLERR,words[1],true,lmp); - } else if (strcmp(words[0],"direct-12-scale") == 0) { - // NOTE: could error check that value = 1 - } else if (strcmp(words[0],"direct-13-scale") == 0) { - } else if (strcmp(words[0],"direct-14-scale") == 0) { + } else if (strcmp(words[0],"direct-12-scale") == 0 || + strcmp(words[0],"direct-13-scale") == 0 || + strcmp(words[0],"direct-14-scale") == 0) { + double tmp = utils::numeric(FLERR,words[1],true,lmp); + if (tmp != 1.0) + error->all(FLERR,"AMOEBA FF file direct-scale 1-2, 1-3, 1-4 values " + "should be 1.0"); } else if (strcmp(words[0],"mutual-11-scale") == 0) { polar_uscale = utils::numeric(FLERR,words[1],true,lmp); - } else if (strcmp(words[0],"mutual-12-scale") == 0) { - // NOTE: could error check that value = 1 - } else if (strcmp(words[0],"mutual-13-scale") == 0) { - } else if (strcmp(words[0],"mutual-14-scale") == 0) { + } else if (strcmp(words[0],"mutual-12-scale") == 0 || + strcmp(words[0],"mutual-13-scale") == 0 || + strcmp(words[0],"mutual-14-scale") == 0) { + double tmp = utils::numeric(FLERR,words[1],true,lmp); + if (tmp != 1.0) + error->all(FLERR,"AMOEBA FF file mutual-scale 1-2, 1-3, 1-4 values " + "should be 1.0"); - } else { - char str[128]; - sprintf(str,"Unrecognized pair amoeba force field definition: %s",words[0]); - error->all(FLERR,str); - } + // error if LAMMPS does not recognize keyword + + } else error->all(FLERR, + "LAMMPS does not recognize AMOEBA PRM file setting {}", + words[0]); } /* ---------------------------------------------------------------------- */ diff --git a/src/AMOEBA/amoeba_induce.cpp b/src/AMOEBA/amoeba_induce.cpp index 1d911177ee..4e5ae7e769 100644 --- a/src/AMOEBA/amoeba_induce.cpp +++ b/src/AMOEBA/amoeba_induce.cpp @@ -943,7 +943,7 @@ void PairAmoeba::umutual1(double **field, double **fieldp) /* ---------------------------------------------------------------------- umutual2b = Ewald real mutual field via list umutual2b computes the real space contribution of the induced - atomic dipole moments to the field via a neighbor list + atomic dipole moments to the field via a neighbor list ------------------------------------------------------------------------- */ void PairAmoeba::umutual2b(double **field, double **fieldp) diff --git a/src/AMOEBA/pair_amoeba.cpp b/src/AMOEBA/pair_amoeba.cpp index d59c0570af..1299d985cd 100644 --- a/src/AMOEBA/pair_amoeba.cpp +++ b/src/AMOEBA/pair_amoeba.cpp @@ -61,6 +61,14 @@ PairAmoeba::PairAmoeba(LAMMPS *lmp) : Pair(lmp) error->all(FLERR,"Pair style amoeba/hippo require newton pair on"); if (domain->dimension == 2) error->all(FLERR,"Pair style amoeba/hippo requires 3d system"); + if (domain->triclinic) + error->all(FLERR,"Pair style amoeba/hippo does not yet support " + "triclinic systems"); + + int nperiodic = domain->xperiodic + domain->yperiodic + domain->zperiodic; + if (nperiodic != 0 && nperiodic != 3) + error->all(FLERR,"Pair style amoeba/hippo requires " + "fully periodic or fully non-periodic system"); me = comm->me; nprocs = comm->nprocs; @@ -79,10 +87,6 @@ PairAmoeba::PairAmoeba(LAMMPS *lmp) : Pair(lmp) amoeba = 1; hippo = 0; - optorder = 0; - maxualt = 0; - tcgnab = 0; - nmax = 0; xaxis2local = yaxis2local = zaxis2local = NULL; rpole = NULL; @@ -1017,7 +1021,7 @@ void PairAmoeba::init_style() comm_reverse = 9; - // request neighbor lists + // request standard neighbor list int irequest = neighbor->request(this,instance_me); } @@ -1825,11 +1829,13 @@ void PairAmoeba::precond_neigh() int *neighptr; // set cutoffs and taper coeffs - // NOTE: should this cutoff include skin = 2.0 ? - // Josh is checking + // add skin to cutoff, same as for main neighbor list choose(USOLV); + //double off = sqrt(off2); + //off2 = (off + neighbor->skin) * (off + neighbor->skin); + // atoms and neighbor list double **x = atom->x; @@ -1839,8 +1845,8 @@ void PairAmoeba::precond_neigh() numneigh = list->numneigh; firstneigh = list->firstneigh; - // store all induce neighs of owned atoms - // scan full neighbor list of I + // store all induce neighs of owned atoms within shorter cutoff + // scan longer-cutoff neighbor list of I ipage_precond->reset(); @@ -1876,6 +1882,10 @@ void PairAmoeba::precond_neigh() /* ---------------------------------------------------------------------- allocate Vdwl arrays + note that n_amclass = # of classes in Tinker PRM file + actual number of classes for atoms in simulation may be smaller + this is determined by the AMOEBA types listed in Tinker xyz file + and their mapping to AMOEBA classes ------------------------------------------------------------------------- */ void PairAmoeba::initialize_vdwl() @@ -1883,9 +1893,6 @@ void PairAmoeba::initialize_vdwl() radmin = radmin4 = epsilon = epsilon4 = NULL; } -// NOTE: n_amclass may be much larger than actual atom classes ?? -// due to format of Tinker PRM file - void PairAmoeba::allocate_vdwl() { memory->create(radmin,n_amclass+1,n_amclass+1,"amoeba:radmin"); @@ -1918,9 +1925,6 @@ void PairAmoeba::initialize_smallsize() void PairAmoeba::allocate_smallsize() { - // NOTE: are optorder and maxualt always initialized ? - // maybe there should be if tests here - // note use of optorder+1 copt = new double[optorder+1]; @@ -2028,7 +2032,7 @@ void PairAmoeba::choose(int which) /* ---------------------------------------------------------------------- compute mixing rules for all pairwise params on a per-class basis override default mixing with VDWLPR entries in force field file - NOTE: not yet processing explicit VDWL14 entries in force field file + no vdwl14 terms are used by AMOEBA or HIPPO force fields ------------------------------------------------------------------------- */ void PairAmoeba::mix() @@ -2387,4 +2391,3 @@ double PairAmoeba::memory_usage() return bytes; } - From 0b3efa4dd63e7e7c3cb2404d2b56f535b508e3c4 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 27 May 2022 17:38:53 -0400 Subject: [PATCH 231/585] set masses from BOP potential files, update unit tests accordingly --- src/MANYBODY/pair_bop.cpp | 52 +- src/MANYBODY/pair_bop.h | 1 + .../force-styles/tests/manybody-pair-bop.yaml | 1032 ++++++++--------- .../tests/manybody-pair-bop_save.yaml | 1032 ++++++++--------- 4 files changed, 1064 insertions(+), 1053 deletions(-) diff --git a/src/MANYBODY/pair_bop.cpp b/src/MANYBODY/pair_bop.cpp index 10e423f2d2..2a9702507d 100644 --- a/src/MANYBODY/pair_bop.cpp +++ b/src/MANYBODY/pair_bop.cpp @@ -95,6 +95,7 @@ PairBOP::PairBOP(LAMMPS *lmp) : Pair(lmp) pairParameters = nullptr; tripletParameters = nullptr; bop_elements = nullptr; + bop_masses = nullptr; bop_types = 0; pairlist1 = nullptr; @@ -183,6 +184,7 @@ PairBOP::~PairBOP() if (bop_elements) for (int i = 0; i < bop_types; i++) delete[] bop_elements[i]; delete[] bop_elements; + delete[] bop_masses; } /* ---------------------------------------------------------------------- */ @@ -344,16 +346,16 @@ void PairBOP::settings(int narg, char **arg) void PairBOP::coeff(int narg, char **arg) { - const int n = atom->ntypes; - delete [] map; - map = new int[n+1]; + const int np1 = atom->ntypes+1; + delete[] map; + map = new int[np1]; memory->destroy(setflag); memory->destroy(cutsq); memory->destroy(cutghost); - memory->create(setflag,n+1,n+1,"BOP:setflag"); - memory->create(cutsq,n+1,n+1,"BOP:cutsq"); - memory->create(cutghost,n+1,n+1,"BOP:cutghost"); - bytes = (n+1)*(n+1) * (sizeof (int) + 2.0*sizeof (double)); + memory->create(setflag,np1,np1,"BOP:setflag"); + memory->create(cutsq,np1,np1,"BOP:cutsq"); + memory->create(cutghost,np1,np1,"BOP:cutghost"); + bytes = np1*np1*(sizeof (int) + 2.0*sizeof (double)); map_element2type(narg-3, arg+3); @@ -365,22 +367,23 @@ void PairBOP::coeff(int narg, char **arg) // and check for missing elements if (comm->me == 0) { - for (int i = 1; i <= n; i++) { + for (int i = 1; i < np1; i++) { int j; if (map[i] >= 0) { for (j = 0; j < bop_types; j++) { - if (strcmp(elements[map[i]],bop_elements[j]) == 0) { + if (strcmp(elements[map[i]], bop_elements[j]) == 0) { map[i] = j; + atom->set_mass(FLERR, i, bop_masses[j]); break; } } if (j == bop_types) error->one(FLERR,"Element {} not found in bop potential file {}", - elements[map[i]],arg[2]); + elements[map[i]], arg[2]); } } } - MPI_Bcast(map,atom->ntypes+1,MPI_INT,0,world); + MPI_Bcast(map,np1,MPI_INT,0,world); } /* ---------------------------------------------------------------------- @@ -1844,9 +1847,10 @@ void PairBOP::read_table(char *filename) PotentialFileReader *reader = nullptr; if (bop_elements) { - for (int i = 0; i < bop_types; i++) delete [] bop_elements[i]; - delete [] bop_elements; + for (int i = 0; i < bop_types; i++) delete[] bop_elements[i]; + delete[] bop_elements; } + delete[] bop_masses; if (comm->me == 0) { try { @@ -1857,10 +1861,11 @@ void PairBOP::read_table(char *filename) "elements",bop_types)); bop_elements = new char*[bop_types]; + bop_masses = new double[bop_types]; for (int i=0; i < bop_types; ++i) { ValueTokenizer values = reader->next_values(3); - values.next_int(); // element number in PTE (ignored) - values.next_double(); // element mass (ignored) + values.next_int(); // element number (ignored) + bop_masses[i] = values.next_double(); // element mass bop_elements[i] = utils::strdup(values.next_string()); } } catch (TokenizerException &e) { @@ -1873,8 +1878,12 @@ void PairBOP::read_table(char *filename) allocate(); memory->create(rcut,npairs,"BOP:rcut"); - // copy element labels to all MPI ranks for use with write_tables() - if (comm->me != 0) bop_elements = new char*[bop_types]; + // copy element labels and masses to all MPI ranks for use with + // write_tables() and to set the per-type masses + if (comm->me != 0) { + bop_elements = new char*[bop_types]; + bop_masses = new double[bop_types]; + } for (int i = 0; i < bop_types; ++i) { int n=0; if (comm->me == 0) n = strlen(bop_elements[i])+1; @@ -1882,6 +1891,7 @@ void PairBOP::read_table(char *filename) if (comm->me != 0) bop_elements[i] = new char[n]; MPI_Bcast(bop_elements[i],n,MPI_CHAR,0,world); } + MPI_Bcast(bop_masses, bop_types, MPI_DOUBLE, 0, world); if (comm->me == 0) { try { @@ -2010,7 +2020,7 @@ void PairBOP::read_table(char *filename) } } } - delete [] singletable; + delete[] singletable; singletable = new double[nr]; for (int i = 0; i < npairs; i++) { @@ -2038,7 +2048,7 @@ void PairBOP::read_table(char *filename) p.betaP = new TabularFunction(); (p.betaP)->set_values(nr, 0.0, rcut[i], singletable); } - delete [] singletable; + delete[] singletable; singletable = new double[nBOt]; for (int i = 0; i < npairs; i++) { @@ -2048,7 +2058,7 @@ void PairBOP::read_table(char *filename) p.bo = new TabularFunction(); (p.bo)->set_values(nBOt, 0.0, 1.0, singletable); } - delete [] singletable; + delete[] singletable; nbuf = 0; for (int i = 0; i < bop_types; i++) { @@ -2102,7 +2112,7 @@ void PairBOP::read_table(char *filename) (p.cphi)->set_values(nr, 0.0, rcut[i], singletable); } } - delete [] singletable; + delete[] singletable; } memory->destroy(rcut); diff --git a/src/MANYBODY/pair_bop.h b/src/MANYBODY/pair_bop.h index aa6da378ae..483675021b 100644 --- a/src/MANYBODY/pair_bop.h +++ b/src/MANYBODY/pair_bop.h @@ -109,6 +109,7 @@ class PairBOP : public Pair { int npairs; // number of element pairs int ntriples; // number of all triples char **bop_elements; // names of elements in potential file + double *bop_masses; // masses of elements in potential file double bytes; int otfly; // = 1 faster, more memory, = 0 slower, less memory diff --git a/unittest/force-styles/tests/manybody-pair-bop.yaml b/unittest/force-styles/tests/manybody-pair-bop.yaml index f809a2db66..28a7acb198 100644 --- a/unittest/force-styles/tests/manybody-pair-bop.yaml +++ b/unittest/force-styles/tests/manybody-pair-bop.yaml @@ -1,7 +1,7 @@ --- -lammps_version: 8 Apr 2021 +lammps_version: 4 May 2022 tags: slow, unstable -date_generated: Wed May 5 11:50:15 2021 +date_generated: Fri May 27 17:36:36 2022 epsilon: 5e-12 prerequisites: ! | pair bop @@ -535,521 +535,521 @@ init_forces: ! |2 510 -3.4726171480710488e+00 5.2740849860611352e+00 -2.8158025166462988e+00 511 9.0442915573980152e+00 -1.4095415165544551e+00 -3.3538829159648067e+00 512 5.7753579505879529e+00 5.6893699296338545e+00 6.1188593723557538e+00 -run_vdwl: -228.0857232848286 +run_vdwl: -227.61849029256774 run_coul: 0 run_stress: ! |2- - 2.3717664948296933e+03 2.4019359900230493e+03 2.4442550920472167e+03 -1.1171763120435550e+02 5.0043476869247547e+02 6.0439649265925254e+01 + 2.3726345230237625e+03 2.4028091143998217e+03 2.4451861002359515e+03 -1.1183772133730268e+02 5.0092092646568466e+02 6.0406121385816192e+01 run_forces: ! |2 - 1 1.4091839800546253e+00 1.7360548678936558e+00 -1.6202615165179715e+00 - 2 -5.8365574626504397e+00 -1.1219252071695536e+00 -1.1485581230473687e+00 - 3 8.7637315082564093e-01 3.3462961780072593e+00 -8.1354040756307189e-01 - 4 1.6600848436445121e+00 1.3250424500391154e+00 -4.9591553993549979e+00 - 5 -9.4927377308725691e-01 -5.8207744490732232e+00 6.4663694433556507e-01 - 6 -4.5177611467364664e-01 4.9415963080206229e+00 1.9433161156269956e+00 - 7 -4.3027400171982393e+00 -4.5613754557341322e+00 1.5699407701143435e+00 - 8 1.5448724473390376e+00 2.4584923079749230e+00 -3.1392452600363878e+00 - 9 -4.6016718693843153e+00 -3.9418857354937766e+00 -4.6668302285853835e+00 - 10 3.7018520600616955e-01 -4.8332896704450473e-01 -3.6854125040532786e+00 - 11 3.8659815227919547e+00 -7.4539979597211152e+00 2.6942416612670450e+00 - 12 -5.6142785099940076e+00 -6.2018561025018917e+00 -6.7409137682125495e+00 - 13 3.3341288429707544e-02 7.0519544225452178e+00 -2.0938812825267012e+00 - 14 -2.3615309773794069e+00 5.8104716217346990e+00 9.3010131683171504e-01 - 15 -2.6654393381699402e+00 7.5481721396936594e+00 -4.8904771244982825e+00 - 16 2.6741244163087328e+00 -5.1059307299887957e-01 7.8828856576674111e+00 - 17 5.6945314250833210e+00 4.7236054837728565e+00 -4.4884300671396336e+00 - 18 -4.9761430158760209e+00 4.0936541714453316e+00 3.2051110415901922e+00 - 19 -1.6198356152349742e+00 -4.2596509866650072e+00 -9.7002992061957471e-01 - 20 -5.1699166766819040e+00 5.8976607613037011e+00 5.9849768421212906e+00 - 21 4.2290116365363856e-01 -1.5086464242159887e+00 -7.5078846485188153e+00 - 22 -8.4609751614699586e+00 5.8493355421305973e+00 -5.7089940793026637e+00 - 23 3.4912598028285822e+00 5.3853907974679593e+00 1.6584479527211395e+00 - 24 1.8362372044284656e-01 -4.7948186173622354e-01 -2.0243825542595988e+00 - 25 1.2730663338573691e+00 -1.9548047760834759e+00 4.6007887784914328e+00 - 26 -8.1062754396295733e-01 9.5001973866788880e-01 1.5848621098705411e+00 - 27 2.9207013772019144e+00 -2.0240243823080113e+00 2.7543470586622281e+00 - 28 -1.9402618680197214e+00 7.6549971705972641e-01 9.6946223555320525e+00 - 29 -3.0268260302352505e+00 3.3951011598221985e+00 -6.0757634768923703e+00 - 30 -1.9700043289182680e+00 2.6914206295193162e+00 -1.5061070030578796e+00 - 31 2.8594848783134941e+00 6.6367269634963255e-01 9.9964131902303999e-01 - 32 -1.2590521565572954e+00 -1.6706345370948841e+00 1.4597870772587420e+00 - 33 5.2588945057830436e+00 -6.0464310077477723e+00 6.8597153738814773e+00 - 34 2.8448145000609104e+00 5.6236407582631842e-01 -4.0638613838727838e-01 - 35 2.7571144480951317e+00 -5.8841374694732007e+00 2.6747482982066044e+00 - 36 -1.9192646875023509e-01 -2.6023930451114428e+00 -1.5640119155534091e-01 - 37 -5.4277214420897915e+00 3.1852614984002408e+00 -2.4472993211497069e+00 - 38 -4.8829690006288995e-01 -2.0914391804220553e+00 1.0262204003397455e+00 - 39 2.9502456290286450e-01 1.3059788537887589e+00 1.7852903388433070e+00 - 40 6.5687025583215677e+00 -3.2783217210449340e+00 -2.4974953961406459e+00 - 41 -7.4527219588534566e-01 -3.7773273742840128e+00 -3.6783380789496833e-01 - 42 -6.1270209507454068e+00 -1.5901032532179344e+00 -1.1669470951126529e-01 - 43 -7.0828155566329834e-02 -9.2972356408781369e+00 5.2769209282642726e-01 - 44 5.4887681221692448e+00 -3.9815332474492124e+00 1.7266076926660758e+00 - 45 -1.9921597783097496e+00 1.3642870044413555e+00 -4.6177186619298967e+00 - 46 -6.8118072835900800e-01 -2.7253513128249764e+00 7.9371605940428696e+00 - 47 3.2952236042706704e+00 2.5414480916905644e+00 6.4494852848836288e+00 - 48 2.9835802286197355e+00 1.1522845567074034e+00 -1.1774469162360268e+00 - 49 -6.0679352021219888e+00 -5.9494385654760693e+00 -6.5551986540445517e+00 - 50 -4.0299132290613233e+00 2.1291409567037674e+00 2.7727907241961174e+00 - 51 -2.3315178667160565e+00 3.2375780159414047e+00 6.0916752443950006e+00 - 52 6.6009431885726491e+00 -4.7168574935074661e+00 7.0071311712598190e+00 - 53 3.4640998460185974e+00 4.1341203040088157e+00 2.5043659364606916e+00 - 54 4.2313664783554278e-01 9.2836044096516734e-01 2.5711772833601865e-01 - 55 6.8701154820027910e-01 -4.3825288825994662e+00 -4.6893514588412790e+00 - 56 -1.6845639332386897e+00 3.5356453384345543e+00 -1.8031520110784989e+00 - 57 4.3948311874190343e-01 -2.8873991420822103e+00 -5.7260145606027968e-01 - 58 3.7547819930218109e+00 5.5227522115963879e-01 1.0948274788664087e+00 - 59 4.8388625830553575e+00 8.6992010344280346e-01 -2.9595243733787004e+00 - 60 -3.0285031145622288e+00 -5.5670095107571873e+00 -3.9776832268195546e+00 - 61 -1.4978080653463104e+00 3.0694094674274295e+00 -1.9187559852475968e+00 - 62 -3.4577019435275798e+00 5.2617491012301256e+00 -2.8027640497219033e+00 - 63 9.0406901956571506e+00 -1.4351168204017049e+00 -3.3870294281189954e+00 - 64 5.8184132257283601e+00 5.7423395615017503e+00 6.1686687899852943e+00 - 65 1.4091839800546091e+00 1.7360548678936276e+00 -1.6202615165179453e+00 - 66 -5.8365574626504042e+00 -1.1219252071695365e+00 -1.1485581230473523e+00 - 67 8.7637315082562395e-01 3.3462961780072549e+00 -8.1354040756305013e-01 - 68 1.6600848436444982e+00 1.3250424500390969e+00 -4.9591553993550184e+00 - 69 -9.4927377308727079e-01 -5.8207744490732196e+00 6.4663694433557561e-01 - 70 -4.5177611467371359e-01 4.9415963080206087e+00 1.9433161156269700e+00 - 71 -4.3027400171981860e+00 -4.5613754557341313e+00 1.5699407701143309e+00 - 72 1.5448724473390880e+00 2.4584923079749119e+00 -3.1392452600363598e+00 - 73 -4.6016718693843179e+00 -3.9418857354937904e+00 -4.6668302285853933e+00 - 74 3.7018520600611565e-01 -4.8332896704455658e-01 -3.6854125040533190e+00 - 75 3.8659815227919081e+00 -7.4539979597211170e+00 2.6942416612669851e+00 - 76 -5.6142785099940484e+00 -6.2018561025019636e+00 -6.7409137682126188e+00 - 77 3.3341288429698641e-02 7.0519544225452115e+00 -2.0938812825266471e+00 - 78 -2.3615309773793371e+00 5.8104716217347496e+00 9.3010131683171282e-01 - 79 -2.6654393381699286e+00 7.5481721396937189e+00 -4.8904771244982861e+00 - 80 2.6741244163088513e+00 -5.1059307299879653e-01 7.8828856576673925e+00 - 81 5.6945314250833485e+00 4.7236054837729018e+00 -4.4884300671396673e+00 - 82 -4.9761430158760085e+00 4.0936541714453112e+00 3.2051110415901745e+00 - 83 -1.6198356152349553e+00 -4.2596509866650010e+00 -9.7002992061954396e-01 - 84 -5.1699166766819218e+00 5.8976607613037313e+00 5.9849768421213101e+00 - 85 4.2290116365360830e-01 -1.5086464242159534e+00 -7.5078846485188153e+00 - 86 -8.4609751614699515e+00 5.8493355421306115e+00 -5.7089940793026734e+00 - 87 3.4912598028285755e+00 5.3853907974679567e+00 1.6584479527211322e+00 - 88 1.8362372044284120e-01 -4.7948186173621893e-01 -2.0243825542596210e+00 - 89 1.2730663338573700e+00 -1.9548047760834715e+00 4.6007887784914239e+00 - 90 -8.1062754396290859e-01 9.5001973866786249e-01 1.5848621098705404e+00 - 91 2.9207013772017723e+00 -2.0240243823080144e+00 2.7543470586622449e+00 - 92 -1.9402618680196801e+00 7.6549971705967934e-01 9.6946223555319726e+00 - 93 -3.0268260302352554e+00 3.3951011598221945e+00 -6.0757634768923277e+00 - 94 -1.9700043289182931e+00 2.6914206295193250e+00 -1.5061070030579018e+00 - 95 2.8594848783135531e+00 6.6367269634966275e-01 9.9964131902307751e-01 - 96 -1.2590521565573098e+00 -1.6706345370949101e+00 1.4597870772587667e+00 - 97 5.2588945057830268e+00 -6.0464310077477323e+00 6.8597153738814338e+00 - 98 2.8448145000609459e+00 5.6236407582631776e-01 -4.0638613838727583e-01 - 99 2.7571144480951344e+00 -5.8841374694732096e+00 2.6747482982066115e+00 - 100 -1.9192646875021221e-01 -2.6023930451114299e+00 -1.5640119155531357e-01 - 101 -5.4277214420898057e+00 3.1852614984002399e+00 -2.4472993211497096e+00 - 102 -4.8829690006288684e-01 -2.0914391804220518e+00 1.0262204003397439e+00 - 103 2.9502456290286061e-01 1.3059788537887580e+00 1.7852903388433101e+00 - 104 6.5687025583215517e+00 -3.2783217210449567e+00 -2.4974953961406721e+00 - 105 -7.4527219588536497e-01 -3.7773273742839950e+00 -3.6783380789499104e-01 - 106 -6.1270209507453357e+00 -1.5901032532179249e+00 -1.1669470951123816e-01 - 107 -7.0828155566327294e-02 -9.2972356408781422e+00 5.2769209282642626e-01 - 108 5.4887681221692626e+00 -3.9815332474491845e+00 1.7266076926660832e+00 - 109 -1.9921597783097735e+00 1.3642870044413722e+00 -4.6177186619298798e+00 - 110 -6.8118072835906096e-01 -2.7253513128250360e+00 7.9371605940428580e+00 - 111 3.2952236042706859e+00 2.5414480916905875e+00 6.4494852848836022e+00 - 112 2.9835802286197390e+00 1.1522845567073714e+00 -1.1774469162360239e+00 - 113 -6.0679352021219684e+00 -5.9494385654760613e+00 -6.5551986540445384e+00 - 114 -4.0299132290613144e+00 2.1291409567037727e+00 2.7727907241961218e+00 - 115 -2.3315178667161041e+00 3.2375780159414287e+00 6.0916752443949900e+00 - 116 6.6009431885726535e+00 -4.7168574935074643e+00 7.0071311712598208e+00 - 117 3.4640998460186023e+00 4.1341203040087846e+00 2.5043659364606894e+00 - 118 4.2313664783553978e-01 9.2836044096515802e-01 2.5711772833601421e-01 - 119 6.8701154820031629e-01 -4.3825288825994786e+00 -4.6893514588413003e+00 - 120 -1.6845639332386861e+00 3.5356453384345410e+00 -1.8031520110784927e+00 - 121 4.3948311874188917e-01 -2.8873991420822134e+00 -5.7260145606029789e-01 - 122 3.7547819930217514e+00 5.5227522115965222e-01 1.0948274788664214e+00 - 123 4.8388625830553638e+00 8.6992010344286652e-01 -2.9595243733787253e+00 - 124 -3.0285031145622474e+00 -5.5670095107572228e+00 -3.9776832268195599e+00 - 125 -1.4978080653462371e+00 3.0694094674273988e+00 -1.9187559852475717e+00 - 126 -3.4577019435275544e+00 5.2617491012301194e+00 -2.8027640497218846e+00 - 127 9.0406901956570831e+00 -1.4351168204016738e+00 -3.3870294281189564e+00 - 128 5.8184132257283823e+00 5.7423395615017734e+00 6.1686687899853228e+00 - 129 1.4091839800546262e+00 1.7360548678936576e+00 -1.6202615165179723e+00 - 130 -5.8365574626504797e+00 -1.1219252071695895e+00 -1.1485581230474180e+00 - 131 8.7637315082564471e-01 3.3462961780072598e+00 -8.1354040756308077e-01 - 132 1.6600848436445128e+00 1.3250424500391194e+00 -4.9591553993550068e+00 - 133 -9.4927377308727179e-01 -5.8207744490732294e+00 6.4663694433557239e-01 - 134 -4.5177611467362117e-01 4.9415963080207082e+00 1.9433161156270105e+00 - 135 -4.3027400171982793e+00 -4.5613754557341561e+00 1.5699407701143815e+00 - 136 1.5448724473390563e+00 2.4584923079749159e+00 -3.1392452600363714e+00 - 137 -4.6016718693843144e+00 -3.9418857354937753e+00 -4.6668302285853827e+00 - 138 3.7018520600622984e-01 -4.8332896704440742e-01 -3.6854125040532595e+00 - 139 3.8659815227919525e+00 -7.4539979597211019e+00 2.6942416612670450e+00 - 140 -5.6142785099939303e+00 -6.2018561025018357e+00 -6.7409137682124802e+00 - 141 3.3341288429728076e-02 7.0519544225451920e+00 -2.0938812825267035e+00 - 142 -2.3615309773794757e+00 5.8104716217346404e+00 9.3010131683171671e-01 - 143 -2.6654393381699402e+00 7.5481721396936461e+00 -4.8904771244982834e+00 - 144 2.6741244163086333e+00 -5.1059307299897860e-01 7.8828856576673560e+00 - 145 5.6945314250833707e+00 4.7236054837728840e+00 -4.4884300671396726e+00 - 146 -4.9761430158760191e+00 4.0936541714453032e+00 3.2051110415901620e+00 - 147 -1.6198356152349958e+00 -4.2596509866650010e+00 -9.7002992061956783e-01 - 148 -5.1699166766818863e+00 5.8976607613036949e+00 5.9849768421212746e+00 - 149 4.2290116365364921e-01 -1.5086464242159900e+00 -7.5078846485187789e+00 - 150 -8.4609751614698947e+00 5.8493355421305795e+00 -5.7089940793025864e+00 - 151 3.4912598028285577e+00 5.3853907974679300e+00 1.6584479527210887e+00 - 152 1.8362372044285138e-01 -4.7948186173622748e-01 -2.0243825542596010e+00 - 153 1.2730663338573589e+00 -1.9548047760834706e+00 4.6007887784914407e+00 - 154 -8.1062754396295622e-01 9.5001973866790146e-01 1.5848621098705276e+00 - 155 2.9207013772019210e+00 -2.0240243823079465e+00 2.7543470586622285e+00 - 156 -1.9402618680196846e+00 7.6549971705969444e-01 9.6946223555320881e+00 - 157 -3.0268260302352421e+00 3.3951011598221883e+00 -6.0757634768923596e+00 - 158 -1.9700043289182823e+00 2.6914206295193281e+00 -1.5061070030578914e+00 - 159 2.8594848783134799e+00 6.6367269634961612e-01 9.9964131902302389e-01 - 160 -1.2590521565572945e+00 -1.6706345370948830e+00 1.4597870772587422e+00 - 161 5.2588945057830347e+00 -6.0464310077477634e+00 6.8597153738814649e+00 - 162 2.8448145000609006e+00 5.6236407582631753e-01 -4.0638613838727305e-01 - 163 2.7571144480951171e+00 -5.8841374694731856e+00 2.6747482982065893e+00 - 164 -1.9192646875022240e-01 -2.6023930451114894e+00 -1.5640119155535331e-01 - 165 -5.4277214420897808e+00 3.1852614984002225e+00 -2.4472993211496825e+00 - 166 -4.8829690006287696e-01 -2.0914391804220371e+00 1.0262204003397262e+00 - 167 2.9502456290285922e-01 1.3059788537887549e+00 1.7852903388433095e+00 - 168 6.5687025583215606e+00 -3.2783217210448306e+00 -2.4974953961405961e+00 - 169 -7.4527219588535520e-01 -3.7773273742840203e+00 -3.6783380789497599e-01 - 170 -6.1270209507453561e+00 -1.5901032532178929e+00 -1.1669470951122371e-01 - 171 -7.0828155566336093e-02 -9.2972356408781778e+00 5.2769209282642715e-01 - 172 5.4887681221692297e+00 -3.9815332474491942e+00 1.7266076926660836e+00 - 173 -1.9921597783097551e+00 1.3642870044414022e+00 -4.6177186619299277e+00 - 174 -6.8118072835905086e-01 -2.7253513128250400e+00 7.9371605940428234e+00 - 175 3.2952236042707121e+00 2.5414480916905955e+00 6.4494852848836448e+00 - 176 2.9835802286197262e+00 1.1522845567073772e+00 -1.1774469162360333e+00 - 177 -6.0679352021219577e+00 -5.9494385654760586e+00 -6.5551986540445260e+00 - 178 -4.0299132290613331e+00 2.1291409567038042e+00 2.7727907241961618e+00 - 179 -2.3315178667160339e+00 3.2375780159413421e+00 6.0916752443949624e+00 - 180 6.6009431885726331e+00 -4.7168574935073542e+00 7.0071311712597613e+00 - 181 3.4640998460185690e+00 4.1341203040087091e+00 2.5043659364606543e+00 - 182 4.2313664783553157e-01 9.2836044096514914e-01 2.5711772833600383e-01 - 183 6.8701154820023480e-01 -4.3825288825994866e+00 -4.6893514588412284e+00 - 184 -1.6845639332386739e+00 3.5356453384345174e+00 -1.8031520110784816e+00 - 185 4.3948311874189067e-01 -2.8873991420822849e+00 -5.7260145606027324e-01 - 186 3.7547819930217967e+00 5.5227522115971683e-01 1.0948274788663654e+00 - 187 4.8388625830553762e+00 8.6992010344279525e-01 -2.9595243733786960e+00 - 188 -3.0285031145621746e+00 -5.5670095107571624e+00 -3.9776832268194866e+00 - 189 -1.4978080653462702e+00 3.0694094674274521e+00 -1.9187559852476039e+00 - 190 -3.4577019435276188e+00 5.2617491012301558e+00 -2.8027640497219370e+00 - 191 9.0406901956571559e+00 -1.4351168204017077e+00 -3.3870294281189914e+00 - 192 5.8184132257283103e+00 5.7423395615017139e+00 6.1686687899852446e+00 - 193 1.4091839800546093e+00 1.7360548678936290e+00 -1.6202615165179461e+00 - 194 -5.8365574626504371e+00 -1.1219252071695649e+00 -1.1485581230473914e+00 - 195 8.7637315082562739e-01 3.3462961780072562e+00 -8.1354040756305857e-01 - 196 1.6600848436444939e+00 1.3250424500390929e+00 -4.9591553993550193e+00 - 197 -9.4927377308727623e-01 -5.8207744490732205e+00 6.4663694433557373e-01 - 198 -4.5177611467370399e-01 4.9415963080207055e+00 1.9433161156269694e+00 - 199 -4.3027400171982224e+00 -4.5613754557341482e+00 1.5699407701143533e+00 - 200 1.5448724473391100e+00 2.4584923079749044e+00 -3.1392452600363372e+00 - 201 -4.6016718693843250e+00 -3.9418857354937971e+00 -4.6668302285854049e+00 - 202 3.7018520600617483e-01 -4.8332896704447248e-01 -3.6854125040533079e+00 - 203 3.8659815227919072e+00 -7.4539979597211037e+00 2.6942416612669855e+00 - 204 -5.6142785099939756e+00 -6.2018561025019112e+00 -6.7409137682125593e+00 - 205 3.3341288429723184e-02 7.0519544225452000e+00 -2.0938812825266298e+00 - 206 -2.3615309773793909e+00 5.8104716217346848e+00 9.3010131683171882e-01 - 207 -2.6654393381699286e+00 7.5481721396937065e+00 -4.8904771244982843e+00 - 208 2.6741244163087501e+00 -5.1059307299888446e-01 7.8828856576673472e+00 - 209 5.6945314250834000e+00 4.7236054837729293e+00 -4.4884300671397064e+00 - 210 -4.9761430158760129e+00 4.0936541714452908e+00 3.2051110415901496e+00 - 211 -1.6198356152349811e+00 -4.2596509866650010e+00 -9.7002992061953830e-01 - 212 -5.1699166766818969e+00 5.8976607613037153e+00 5.9849768421212861e+00 - 213 4.2290116365362329e-01 -1.5086464242159563e+00 -7.5078846485187913e+00 - 214 -8.4609751614698805e+00 5.8493355421305875e+00 -5.7089940793025908e+00 - 215 3.4912598028285524e+00 5.3853907974679327e+00 1.6584479527210902e+00 - 216 1.8362372044285205e-01 -4.7948186173622875e-01 -2.0243825542596166e+00 - 217 1.2730663338573596e+00 -1.9548047760834673e+00 4.6007887784914319e+00 - 218 -8.1062754396291825e-01 9.5001973866788747e-01 1.5848621098705231e+00 - 219 2.9207013772017865e+00 -2.0240243823079682e+00 2.7543470586622534e+00 - 220 -1.9402618680196495e+00 7.6549971705965802e-01 9.6946223555319992e+00 - 221 -3.0268260302352465e+00 3.3951011598221861e+00 -6.0757634768923250e+00 - 222 -1.9700043289183065e+00 2.6914206295193375e+00 -1.5061070030579118e+00 - 223 2.8594848783135434e+00 6.6367269634964043e-01 9.9964131902305564e-01 - 224 -1.2590521565573090e+00 -1.6706345370949087e+00 1.4597870772587664e+00 - 225 5.2588945057830188e+00 -6.0464310077477252e+00 6.8597153738814240e+00 - 226 2.8448145000609286e+00 5.6236407582631165e-01 -4.0638613838726467e-01 - 227 2.7571144480951206e+00 -5.8841374694731945e+00 2.6747482982065973e+00 - 228 -1.9192646875019609e-01 -2.6023930451114792e+00 -1.5640119155531521e-01 - 229 -5.4277214420897950e+00 3.1852614984002243e+00 -2.4472993211496865e+00 - 230 -4.8829690006287513e-01 -2.0914391804220358e+00 1.0262204003397262e+00 - 231 2.9502456290285423e-01 1.3059788537887522e+00 1.7852903388433130e+00 - 232 6.5687025583215490e+00 -3.2783217210448430e+00 -2.4974953961406290e+00 - 233 -7.4527219588536520e-01 -3.7773273742840128e+00 -3.6783380789498865e-01 - 234 -6.1270209507452833e+00 -1.5901032532178778e+00 -1.1669470951119659e-01 - 235 -7.0828155566330805e-02 -9.2972356408781796e+00 5.2769209282642604e-01 - 236 5.4887681221692430e+00 -3.9815332474491538e+00 1.7266076926660721e+00 - 237 -1.9921597783097837e+00 1.3642870044414115e+00 -4.6177186619299029e+00 - 238 -6.8118072835910659e-01 -2.7253513128251061e+00 7.9371605940428100e+00 - 239 3.2952236042707228e+00 2.5414480916906115e+00 6.4494852848836217e+00 - 240 2.9835802286197284e+00 1.1522845567073488e+00 -1.1774469162360306e+00 - 241 -6.0679352021219364e+00 -5.9494385654760569e+00 -6.5551986540445197e+00 - 242 -4.0299132290613189e+00 2.1291409567038055e+00 2.7727907241961627e+00 - 243 -2.3315178667160752e+00 3.2375780159413567e+00 6.0916752443949562e+00 - 244 6.6009431885726286e+00 -4.7168574935073488e+00 7.0071311712597506e+00 - 245 3.4640998460185721e+00 4.1341203040086913e+00 2.5043659364606583e+00 - 246 4.2313664783552735e-01 9.2836044096513803e-01 2.5711772833599877e-01 - 247 6.8701154820027677e-01 -4.3825288825994866e+00 -4.6893514588412462e+00 - 248 -1.6845639332386573e+00 3.5356453384344939e+00 -1.8031520110784616e+00 - 249 4.3948311874186885e-01 -2.8873991420822955e+00 -5.7260145606028601e-01 - 250 3.7547819930217283e+00 5.5227522115973815e-01 1.0948274788663759e+00 - 251 4.8388625830553877e+00 8.6992010344286119e-01 -2.9595243733787218e+00 - 252 -3.0285031145621910e+00 -5.5670095107571829e+00 -3.9776832268194813e+00 - 253 -1.4978080653461978e+00 3.0694094674274215e+00 -1.9187559852475764e+00 - 254 -3.4577019435275971e+00 5.2617491012301461e+00 -2.8027640497219215e+00 - 255 9.0406901956570884e+00 -1.4351168204016764e+00 -3.3870294281189546e+00 - 256 5.8184132257283228e+00 5.7423395615017272e+00 6.1686687899852624e+00 - 257 1.4091839800546311e+00 1.7360548678936627e+00 -1.6202615165179777e+00 - 258 -5.8365574626504619e+00 -1.1219252071695709e+00 -1.1485581230473791e+00 - 259 8.7637315082562439e-01 3.3462961780072389e+00 -8.1354040756305923e-01 - 260 1.6600848436445086e+00 1.3250424500391138e+00 -4.9591553993549988e+00 - 261 -9.4927377308725214e-01 -5.8207744490732276e+00 6.4663694433556207e-01 - 262 -4.5177611467360057e-01 4.9415963080206202e+00 1.9433161156270420e+00 - 263 -4.3027400171982570e+00 -4.5613754557341517e+00 1.5699407701143941e+00 - 264 1.5448724473390543e+00 2.4584923079749084e+00 -3.1392452600363963e+00 - 265 -4.6016718693843126e+00 -3.9418857354937775e+00 -4.6668302285853844e+00 - 266 3.7018520600613297e-01 -4.8332896704450973e-01 -3.6854125040533261e+00 - 267 3.8659815227919201e+00 -7.4539979597210992e+00 2.6942416612670250e+00 - 268 -5.6142785099940120e+00 -6.2018561025018997e+00 -6.7409137682125522e+00 - 269 3.3341288429739352e-02 7.0519544225451858e+00 -2.0938812825266968e+00 - 270 -2.3615309773793465e+00 5.8104716217346795e+00 9.3010131683181696e-01 - 271 -2.6654393381700139e+00 7.5481721396937509e+00 -4.8904771244983651e+00 - 272 2.6741244163087305e+00 -5.1059307299888756e-01 7.8828856576674111e+00 - 273 5.6945314250833396e+00 4.7236054837728716e+00 -4.4884300671396442e+00 - 274 -4.9761430158759961e+00 4.0936541714453289e+00 3.2051110415901976e+00 - 275 -1.6198356152349642e+00 -4.2596509866649948e+00 -9.7002992061955196e-01 - 276 -5.1699166766818871e+00 5.8976607613036709e+00 5.9849768421212586e+00 - 277 4.2290116365361424e-01 -1.5086464242159596e+00 -7.5078846485188082e+00 - 278 -8.4609751614700137e+00 5.8493355421306603e+00 -5.7089940793027392e+00 - 279 3.4912598028285378e+00 5.3853907974679602e+00 1.6584479527211433e+00 - 280 1.8362372044285166e-01 -4.7948186173622959e-01 -2.0243825542595824e+00 - 281 1.2730663338573827e+00 -1.9548047760834801e+00 4.6007887784913599e+00 - 282 -8.1062754396294179e-01 9.5001973866789868e-01 1.5848621098705087e+00 - 283 2.9207013772019419e+00 -2.0240243823079860e+00 2.7543470586622187e+00 - 284 -1.9402618680197097e+00 7.6549971705970477e-01 9.6946223555320827e+00 - 285 -3.0268260302352705e+00 3.3951011598222260e+00 -6.0757634768923667e+00 - 286 -1.9700043289182816e+00 2.6914206295193210e+00 -1.5061070030578938e+00 - 287 2.8594848783134781e+00 6.6367269634964388e-01 9.9964131902304842e-01 - 288 -1.2590521565572959e+00 -1.6706345370948839e+00 1.4597870772587418e+00 - 289 5.2588945057831227e+00 -6.0464310077478611e+00 6.8597153738815528e+00 - 290 2.8448145000609064e+00 5.6236407582631898e-01 -4.0638613838728016e-01 - 291 2.7571144480951801e+00 -5.8841374694731963e+00 2.6747482982066444e+00 - 292 -1.9192646875024974e-01 -2.6023930451114330e+00 -1.5640119155539528e-01 - 293 -5.4277214420898163e+00 3.1852614984002563e+00 -2.4472993211497136e+00 - 294 -4.8829690006289089e-01 -2.0914391804220638e+00 1.0262204003397486e+00 - 295 2.9502456290283852e-01 1.3059788537887378e+00 1.7852903388432688e+00 - 296 6.5687025583215730e+00 -3.2783217210449096e+00 -2.4974953961406419e+00 - 297 -7.4527219588535576e-01 -3.7773273742839897e+00 -3.6783380789497833e-01 - 298 -6.1270209507454059e+00 -1.5901032532179340e+00 -1.1669470951127092e-01 - 299 -7.0828155566327031e-02 -9.2972356408781405e+00 5.2769209282643048e-01 - 300 5.4887681221691862e+00 -3.9815332474491911e+00 1.7266076926660765e+00 - 301 -1.9921597783097464e+00 1.3642870044413813e+00 -4.6177186619299357e+00 - 302 -6.8118072835899479e-01 -2.7253513128250177e+00 7.9371605940428118e+00 - 303 3.2952236042706780e+00 2.5414480916905724e+00 6.4494852848836226e+00 - 304 2.9835802286197115e+00 1.1522845567074216e+00 -1.1774469162359920e+00 - 305 -6.0679352021219408e+00 -5.9494385654760071e+00 -6.5551986540445046e+00 - 306 -4.0299132290613322e+00 2.1291409567037616e+00 2.7727907241961169e+00 - 307 -2.3315178667160326e+00 3.2375780159413909e+00 6.0916752443949980e+00 - 308 6.6009431885727023e+00 -4.7168574935075398e+00 7.0071311712598687e+00 - 309 3.4640998460185570e+00 4.1341203040087589e+00 2.5043659364606148e+00 - 310 4.2313664783553812e-01 9.2836044096518455e-01 2.5711772833601587e-01 - 311 6.8701154820029764e-01 -4.3825288825994893e+00 -4.6893514588412897e+00 - 312 -1.6845639332386757e+00 3.5356453384345401e+00 -1.8031520110784909e+00 - 313 4.3948311874192064e-01 -2.8873991420822258e+00 -5.7260145606024282e-01 - 314 3.7547819930218127e+00 5.5227522115964545e-01 1.0948274788663677e+00 - 315 4.8388625830553504e+00 8.6992010344280335e-01 -2.9595243733787977e+00 - 316 -3.0285031145622927e+00 -5.5670095107572948e+00 -3.9776832268196527e+00 - 317 -1.4978080653463275e+00 3.0694094674273598e+00 -1.9187559852475453e+00 - 318 -3.4577019435275558e+00 5.2617491012301123e+00 -2.8027640497218824e+00 - 319 9.0406901956571719e+00 -1.4351168204016653e+00 -3.3870294281189643e+00 - 320 5.8184132257284507e+00 5.7423395615018444e+00 6.1686687899853681e+00 - 321 1.4091839800546089e+00 1.7360548678936276e+00 -1.6202615165179448e+00 - 322 -5.8365574626504406e+00 -1.1219252071695605e+00 -1.1485581230473683e+00 - 323 8.7637315082560552e-01 3.3462961780072313e+00 -8.1354040756303558e-01 - 324 1.6600848436444902e+00 1.3250424500390892e+00 -4.9591553993550113e+00 - 325 -9.4927377308725713e-01 -5.8207744490732196e+00 6.4663694433556163e-01 - 326 -4.5177611467365764e-01 4.9415963080206184e+00 1.9433161156270236e+00 - 327 -4.3027400171982002e+00 -4.5613754557341464e+00 1.5699407701143666e+00 - 328 1.5448724473390965e+00 2.4584923079749039e+00 -3.1392452600363705e+00 - 329 -4.6016718693843179e+00 -3.9418857354937908e+00 -4.6668302285853951e+00 - 330 3.7018520600608934e-01 -4.8332896704456763e-01 -3.6854125040533510e+00 - 331 3.8659815227918801e+00 -7.4539979597211019e+00 2.6942416612669708e+00 - 332 -5.6142785099940555e+00 -6.2018561025019778e+00 -6.7409137682126294e+00 - 333 3.3341288429725495e-02 7.0519544225451831e+00 -2.0938812825266422e+00 - 334 -2.3615309773792754e+00 5.8104716217347230e+00 9.3010131683181607e-01 - 335 -2.6654393381700006e+00 7.5481721396938086e+00 -4.8904771244983651e+00 - 336 2.6741244163088496e+00 -5.1059307299879952e-01 7.8828856576673969e+00 - 337 5.6945314250833610e+00 4.7236054837729107e+00 -4.4884300671396717e+00 - 338 -4.9761430158759898e+00 4.0936541714453147e+00 3.2051110415901869e+00 - 339 -1.6198356152349376e+00 -4.2596509866649903e+00 -9.7002992061951809e-01 - 340 -5.1699166766819040e+00 5.8976607613036931e+00 5.9849768421212737e+00 - 341 4.2290116365358615e-01 -1.5086464242159290e+00 -7.5078846485188215e+00 - 342 -8.4609751614699995e+00 5.8493355421306745e+00 -5.7089940793027472e+00 - 343 3.4912598028285324e+00 5.3853907974679558e+00 1.6584479527211353e+00 - 344 1.8362372044284778e-01 -4.7948186173622687e-01 -2.0243825542595992e+00 - 345 1.2730663338573833e+00 -1.9548047760834757e+00 4.6007887784913510e+00 - 346 -8.1062754396290182e-01 9.5001973866788081e-01 1.5848621098705074e+00 - 347 2.9207013772018025e+00 -2.0240243823080029e+00 2.7543470586622463e+00 - 348 -1.9402618680196775e+00 7.6549971705966835e-01 9.6946223555320099e+00 - 349 -3.0268260302352754e+00 3.3951011598222234e+00 -6.0757634768923339e+00 - 350 -1.9700043289183056e+00 2.6914206295193304e+00 -1.5061070030579151e+00 - 351 2.8594848783135420e+00 6.6367269634966752e-01 9.9964131902308240e-01 - 352 -1.2590521565573154e+00 -1.6706345370949156e+00 1.4597870772587733e+00 - 353 5.2588945057831102e+00 -6.0464310077478247e+00 6.8597153738815138e+00 - 354 2.8448145000609362e+00 5.6236407582631520e-01 -4.0638613838727428e-01 - 355 2.7571144480951890e+00 -5.8841374694732149e+00 2.6747482982066555e+00 - 356 -1.9192646875022737e-01 -2.6023930451114192e+00 -1.5640119155536478e-01 - 357 -5.4277214420898403e+00 3.1852614984002652e+00 -2.4472993211497220e+00 - 358 -4.8829690006288884e-01 -2.0914391804220620e+00 1.0262204003397475e+00 - 359 2.9502456290283241e-01 1.3059788537887345e+00 1.7852903388432784e+00 - 360 6.5687025583215570e+00 -3.2783217210449371e+00 -2.4974953961406730e+00 - 361 -7.4527219588536464e-01 -3.7773273742839790e+00 -3.6783380789498993e-01 - 362 -6.1270209507453304e+00 -1.5901032532179182e+00 -1.1669470951124647e-01 - 363 -7.0828155566322812e-02 -9.2972356408781422e+00 5.2769209282643037e-01 - 364 5.4887681221691995e+00 -3.9815332474491578e+00 1.7266076926660769e+00 - 365 -1.9921597783097700e+00 1.3642870044413935e+00 -4.6177186619299171e+00 - 366 -6.8118072835905619e-01 -2.7253513128250813e+00 7.9371605940428021e+00 - 367 3.2952236042706891e+00 2.5414480916905897e+00 6.4494852848835995e+00 - 368 2.9835802286197146e+00 1.1522845567073883e+00 -1.1774469162359926e+00 - 369 -6.0679352021219168e+00 -5.9494385654760000e+00 -6.5551986540444913e+00 - 370 -4.0299132290613215e+00 2.1291409567037642e+00 2.7727907241961178e+00 - 371 -2.3315178667160841e+00 3.2375780159414127e+00 6.0916752443949918e+00 - 372 6.6009431885727041e+00 -4.7168574935075362e+00 7.0071311712598670e+00 - 373 3.4640998460185579e+00 4.1341203040087349e+00 2.5043659364606152e+00 - 374 4.2313664783553423e-01 9.2836044096517378e-01 2.5711772833601110e-01 - 375 6.8701154820034405e-01 -4.3825288825995052e+00 -4.6893514588413119e+00 - 376 -1.6845639332386699e+00 3.5356453384345237e+00 -1.8031520110784818e+00 - 377 4.3948311874191232e-01 -2.8873991420822267e+00 -5.7260145606025925e-01 - 378 3.7547819930217545e+00 5.5227522115966277e-01 1.0948274788663754e+00 - 379 4.8388625830553673e+00 8.6992010344286952e-01 -2.9595243733788266e+00 - 380 -3.0285031145623149e+00 -5.5670095107573196e+00 -3.9776832268196500e+00 - 381 -1.4978080653462609e+00 3.0694094674273300e+00 -1.9187559852475262e+00 - 382 -3.4577019435275314e+00 5.2617491012301087e+00 -2.8027640497218647e+00 - 383 9.0406901956570973e+00 -1.4351168204016267e+00 -3.3870294281189155e+00 - 384 5.8184132257284693e+00 5.7423395615018640e+00 6.1686687899853938e+00 - 385 1.4091839800546315e+00 1.7360548678936638e+00 -1.6202615165179781e+00 - 386 -5.8365574626505046e+00 -1.1219252071696144e+00 -1.1485581230474351e+00 - 387 8.7637315082563116e-01 3.3462961780072367e+00 -8.1354040756307044e-01 - 388 1.6600848436445064e+00 1.3250424500391129e+00 -4.9591553993550042e+00 - 389 -9.4927377308726546e-01 -5.8207744490732258e+00 6.4663694433556684e-01 - 390 -4.5177611467357648e-01 4.9415963080207232e+00 1.9433161156270660e+00 - 391 -4.3027400171982926e+00 -4.5613754557341695e+00 1.5699407701144159e+00 - 392 1.5448724473390720e+00 2.4584923079749030e+00 -3.1392452600363780e+00 - 393 -4.6016718693843117e+00 -3.9418857354937766e+00 -4.6668302285853844e+00 - 394 3.7018520600619537e-01 -4.8332896704442380e-01 -3.6854125040533008e+00 - 395 3.8659815227919156e+00 -7.4539979597210850e+00 2.6942416612670224e+00 - 396 -5.6142785099939436e+00 -6.2018561025018535e+00 -6.7409137682124936e+00 - 397 3.3341288429758066e-02 7.0519544225451662e+00 -2.0938812825266919e+00 - 398 -2.3615309773794055e+00 5.8104716217346191e+00 9.3010131683181485e-01 - 399 -2.6654393381700103e+00 7.5481721396937393e+00 -4.8904771244983625e+00 - 400 2.6741244163086249e+00 -5.1059307299898360e-01 7.8828856576673783e+00 - 401 5.6945314250833921e+00 4.7236054837729009e+00 -4.4884300671396842e+00 - 402 -4.9761430158760058e+00 4.0936541714453085e+00 3.2051110415901740e+00 - 403 -1.6198356152349935e+00 -4.2596509866649948e+00 -9.7002992061955384e-01 - 404 -5.1699166766818720e+00 5.8976607613036647e+00 5.9849768421212461e+00 - 405 4.2290116365363556e-01 -1.5086464242159761e+00 -7.5078846485187878e+00 - 406 -8.4609751614699444e+00 5.8493355421306461e+00 -5.7089940793026672e+00 - 407 3.4912598028285289e+00 5.3853907974679265e+00 1.6584479527211002e+00 - 408 1.8362372044286548e-01 -4.7948186173624224e-01 -2.0243825542595810e+00 - 409 1.2730663338573718e+00 -1.9548047760834746e+00 4.6007887784913688e+00 - 410 -8.1062754396295167e-01 9.5001973866792222e-01 1.5848621098704945e+00 - 411 2.9207013772019486e+00 -2.0240243823079398e+00 2.7543470586622174e+00 - 412 -1.9402618680196764e+00 7.6549971705967745e-01 9.6946223555321112e+00 - 413 -3.0268260302352630e+00 3.3951011598222181e+00 -6.0757634768923605e+00 - 414 -1.9700043289182965e+00 2.6914206295193344e+00 -1.5061070030579065e+00 - 415 2.8594848783134728e+00 6.6367269634962867e-01 9.9964131902303588e-01 - 416 -1.2590521565572947e+00 -1.6706345370948832e+00 1.4597870772587422e+00 - 417 5.2588945057831182e+00 -6.0464310077478585e+00 6.8597153738815475e+00 - 418 2.8448145000608931e+00 5.6236407582630721e-01 -4.0638613838726412e-01 - 419 2.7571144480951659e+00 -5.8841374694731785e+00 2.6747482982066311e+00 - 420 -1.9192646875023883e-01 -2.6023930451114814e+00 -1.5640119155539567e-01 - 421 -5.4277214420898057e+00 3.1852614984002399e+00 -2.4472993211496927e+00 - 422 -4.8829690006288184e-01 -2.0914391804220513e+00 1.0262204003397351e+00 - 423 2.9502456290283263e-01 1.3059788537887316e+00 1.7852903388432710e+00 - 424 6.5687025583215677e+00 -3.2783217210447950e+00 -2.4974953961405957e+00 - 425 -7.4527219588536364e-01 -3.7773273742840070e+00 -3.6783380789498238e-01 - 426 -6.1270209507453552e+00 -1.5901032532178907e+00 -1.1669470951122697e-01 - 427 -7.0828155566333456e-02 -9.2972356408781796e+00 5.2769209282642937e-01 - 428 5.4887681221691684e+00 -3.9815332474491631e+00 1.7266076926660745e+00 - 429 -1.9921597783097484e+00 1.3642870044414233e+00 -4.6177186619299526e+00 - 430 -6.8118072835904131e-01 -2.7253513128250795e+00 7.9371605940427647e+00 - 431 3.2952236042707215e+00 2.5414480916906030e+00 6.4494852848836377e+00 - 432 2.9835802286197066e+00 1.1522845567073925e+00 -1.1774469162359951e+00 - 433 -6.0679352021219133e+00 -5.9494385654760107e+00 -6.5551986540444913e+00 - 434 -4.0299132290613429e+00 2.1291409567038064e+00 2.7727907241961693e+00 - 435 -2.3315178667160001e+00 3.2375780159413186e+00 6.0916752443949518e+00 - 436 6.6009431885726855e+00 -4.7168574935074243e+00 7.0071311712598199e+00 - 437 3.4640998460185353e+00 4.1341203040086709e+00 2.5043659364605859e+00 - 438 4.2313664783552257e-01 9.2836044096516035e-01 2.5711772833599683e-01 - 439 6.8701154820026356e-01 -4.3825288825994972e+00 -4.6893514588412382e+00 - 440 -1.6845639332386511e+00 3.5356453384344939e+00 -1.8031520110784645e+00 - 441 4.3948311874190016e-01 -2.8873991420823018e+00 -5.7260145606023594e-01 - 442 3.7547819930217847e+00 5.5227522115972771e-01 1.0948274788663190e+00 - 443 4.8388625830553798e+00 8.6992010344278914e-01 -2.9595243733787910e+00 - 444 -3.0285031145622359e+00 -5.5670095107572628e+00 -3.9776832268195768e+00 - 445 -1.4978080653462962e+00 3.0694094674273931e+00 -1.9187559852475569e+00 - 446 -3.4577019435275989e+00 5.2617491012301478e+00 -2.8027640497219197e+00 - 447 9.0406901956571772e+00 -1.4351168204016671e+00 -3.3870294281189612e+00 - 448 5.8184132257283938e+00 5.7423395615018009e+00 6.1686687899853112e+00 - 449 1.4091839800546093e+00 1.7360548678936290e+00 -1.6202615165179453e+00 - 450 -5.8365574626504761e+00 -1.1219252071695991e+00 -1.1485581230474198e+00 - 451 8.7637315082561329e-01 3.3462961780072291e+00 -8.1354040756304880e-01 - 452 1.6600848436444857e+00 1.3250424500390852e+00 -4.9591553993550166e+00 - 453 -9.4927377308726668e-01 -5.8207744490732178e+00 6.4663694433556518e-01 - 454 -4.5177611467363993e-01 4.9415963080207170e+00 1.9433161156270433e+00 - 455 -4.3027400171982411e+00 -4.5613754557341704e+00 1.5699407701144044e+00 - 456 1.5448724473391180e+00 2.4584923079748955e+00 -3.1392452600363479e+00 - 457 -4.6016718693843259e+00 -3.9418857354937975e+00 -4.6668302285854049e+00 - 458 3.7018520600614979e-01 -4.8332896704448242e-01 -3.6854125040533474e+00 - 459 3.8659815227918859e+00 -7.4539979597210957e+00 2.6942416612669775e+00 - 460 -5.6142785099939916e+00 -6.2018561025019325e+00 -6.7409137682125735e+00 - 461 3.3341288429745382e-02 7.0519544225451831e+00 -2.0938812825266329e+00 - 462 -2.3615309773793238e+00 5.8104716217346590e+00 9.3010131683182995e-01 - 463 -2.6654393381700037e+00 7.5481721396937997e+00 -4.8904771244983696e+00 - 464 2.6741244163087461e+00 -5.1059307299888701e-01 7.8828856576673685e+00 - 465 5.6945314250834205e+00 4.7236054837729471e+00 -4.4884300671397197e+00 - 466 -4.9761430158759863e+00 4.0936541714452837e+00 3.2051110415901523e+00 - 467 -1.6198356152349644e+00 -4.2596509866649894e+00 -9.7002992061952242e-01 - 468 -5.1699166766818836e+00 5.8976607613036842e+00 5.9849768421212559e+00 - 469 4.2290116365359981e-01 -1.5086464242159319e+00 -7.5078846485187869e+00 - 470 -8.4609751614699338e+00 5.8493355421306630e+00 -5.7089940793026788e+00 - 471 3.4912598028285164e+00 5.3853907974679212e+00 1.6584479527210936e+00 - 472 1.8362372044285996e-01 -4.7948186173623775e-01 -2.0243825542596032e+00 - 473 1.2730663338573720e+00 -1.9548047760834697e+00 4.6007887784913590e+00 - 474 -8.1062754396290859e-01 9.5001973866790346e-01 1.5848621098704960e+00 - 475 2.9207013772018131e+00 -2.0240243823079469e+00 2.7543470586622298e+00 - 476 -1.9402618680196426e+00 7.6549971705964004e-01 9.6946223555320401e+00 - 477 -3.0268260302352603e+00 3.3951011598222030e+00 -6.0757634768923214e+00 - 478 -1.9700043289183136e+00 2.6914206295193366e+00 -1.5061070030579211e+00 - 479 2.8594848783135354e+00 6.6367269634965109e-01 9.9964131902306697e-01 - 480 -1.2590521565573143e+00 -1.6706345370949152e+00 1.4597870772587735e+00 - 481 5.2588945057831022e+00 -6.0464310077478167e+00 6.8597153738815031e+00 - 482 2.8448145000609153e+00 5.6236407582631298e-01 -4.0638613838726606e-01 - 483 2.7571144480951641e+00 -5.8841374694731883e+00 2.6747482982066320e+00 - 484 -1.9192646875021480e-01 -2.6023930451114743e+00 -1.5640119155537663e-01 - 485 -5.4277214420898199e+00 3.1852614984002354e+00 -2.4472993211496896e+00 - 486 -4.8829690006287668e-01 -2.0914391804220442e+00 1.0262204003397306e+00 - 487 2.9502456290283036e-01 1.3059788537887318e+00 1.7852903388432808e+00 - 488 6.5687025583215561e+00 -3.2783217210448123e+00 -2.4974953961406214e+00 - 489 -7.4527219588537796e-01 -3.7773273742839950e+00 -3.6783380789500075e-01 - 490 -6.1270209507452824e+00 -1.5901032532178767e+00 -1.1669470951120132e-01 - 491 -7.0828155566328391e-02 -9.2972356408781831e+00 5.2769209282643115e-01 - 492 5.4887681221691782e+00 -3.9815332474491272e+00 1.7266076926660672e+00 - 493 -1.9921597783097722e+00 1.3642870044414399e+00 -4.6177186619299357e+00 - 494 -6.8118072835909582e-01 -2.7253513128251385e+00 7.9371605940427514e+00 - 495 3.2952236042707335e+00 2.5414480916906217e+00 6.4494852848836128e+00 - 496 2.9835802286197026e+00 1.1522845567073692e+00 -1.1774469162360017e+00 - 497 -6.0679352021218858e+00 -5.9494385654759991e+00 -6.5551986540444753e+00 - 498 -4.0299132290613304e+00 2.1291409567037998e+00 2.7727907241961627e+00 - 499 -2.3315178667160503e+00 3.2375780159413483e+00 6.0916752443949553e+00 - 500 6.6009431885726855e+00 -4.7168574935074252e+00 7.0071311712598181e+00 - 501 3.4640998460185322e+00 4.1341203040086407e+00 2.5043659364605859e+00 - 502 4.2313664783552291e-01 9.2836044096515435e-01 2.5711772833599639e-01 - 503 6.8701154820029697e-01 -4.3825288825995079e+00 -4.6893514588412568e+00 - 504 -1.6845639332386459e+00 3.5356453384344828e+00 -1.8031520110784556e+00 - 505 4.3948311874188511e-01 -2.8873991420823044e+00 -5.7260145606025570e-01 - 506 3.7547819930217337e+00 5.5227522115974215e-01 1.0948274788663341e+00 - 507 4.8388625830553869e+00 8.6992010344284987e-01 -2.9595243733788110e+00 - 508 -3.0285031145622705e+00 -5.5670095107572886e+00 -3.9776832268195808e+00 - 509 -1.4978080653462185e+00 3.0694094674273678e+00 -1.9187559852475351e+00 - 510 -3.4577019435275704e+00 5.2617491012301310e+00 -2.8027640497218980e+00 - 511 9.0406901956571009e+00 -1.4351168204016298e+00 -3.3870294281189146e+00 - 512 5.8184132257284160e+00 5.7423395615018249e+00 6.1686687899853405e+00 + 1 1.4101084499624834e+00 1.7371804088545335e+00 -1.6213174412210642e+00 + 2 -5.8399142482199666e+00 -1.1232412828534912e+00 -1.1499478454746312e+00 + 3 8.7634281400132430e-01 3.3470924205892643e+00 -8.1366156642161969e-01 + 4 1.6618348954343425e+00 1.3267230795340910e+00 -4.9613186302807133e+00 + 5 -9.5068329765370274e-01 -5.8237800850819283e+00 6.4731385586130707e-01 + 6 -4.5001292021627554e-01 4.9457441409187863e+00 1.9456461634790387e+00 + 7 -4.3052102443920397e+00 -4.5636488830761017e+00 1.5724677428331195e+00 + 8 1.5449878373122821e+00 2.4590982230198160e+00 -3.1390852730039449e+00 + 9 -4.6045449943310786e+00 -3.9440808098823186e+00 -4.6700755874078377e+00 + 10 3.7147697382426104e-01 -4.8285079070936388e-01 -3.6890671668077557e+00 + 11 3.8716570366709617e+00 -7.4579362411464825e+00 2.6984541425925990e+00 + 12 -5.6224994178130929e+00 -6.2110127059234488e+00 -6.7476211894063383e+00 + 13 3.1500132936973006e-02 7.0601764306126391e+00 -2.0944606590553625e+00 + 14 -2.3637150235790640e+00 5.8159045954962254e+00 9.2704917537069798e-01 + 15 -2.6728293943632440e+00 7.5552531622542345e+00 -4.8983926692927886e+00 + 16 2.6753525054676741e+00 -5.0623527488437536e-01 7.8939421082827286e+00 + 17 5.6999696634920580e+00 4.7279269674034090e+00 -4.4920700577050896e+00 + 18 -4.9787999902374374e+00 4.0981651408694857e+00 3.2088541364653502e+00 + 19 -1.6213391901712033e+00 -4.2635561713516781e+00 -9.7236351460329395e-01 + 20 -5.1758925760643937e+00 5.9036888087723742e+00 5.9897804863834523e+00 + 21 4.2475360018693586e-01 -1.5120403153751463e+00 -7.5118946585359554e+00 + 22 -8.4723991427858429e+00 5.8591586936795998e+00 -5.7220550448276519e+00 + 23 3.4936529015452429e+00 5.3887932178421343e+00 1.6618586990387023e+00 + 24 1.8397684085288479e-01 -4.7956123656856936e-01 -2.0248730631499297e+00 + 25 1.2740119839669743e+00 -1.9562152526426297e+00 4.6010648854407039e+00 + 26 -8.1088651153479652e-01 9.4981098330250502e-01 1.5857688839887338e+00 + 27 2.9237941762954156e+00 -2.0287483220568965e+00 2.7576412015032452e+00 + 28 -1.9423484320868827e+00 7.6700165963422506e-01 9.7032907448379735e+00 + 29 -3.0301266998673522e+00 3.3988629573493792e+00 -6.0790525480058077e+00 + 30 -1.9710732697574975e+00 2.6918587726715142e+00 -1.5068617145526664e+00 + 31 2.8596379254927973e+00 6.6388605559368985e-01 1.0001582081953555e+00 + 32 -1.2599066151315841e+00 -1.6716649508562782e+00 1.4607750060248941e+00 + 33 5.2650618358415651e+00 -6.0531728072803412e+00 6.8677797616117395e+00 + 34 2.8452772301515119e+00 5.6278916247943778e-01 -4.0654825176947501e-01 + 35 2.7601000342468174e+00 -5.8880962871766309e+00 2.6779862817975464e+00 + 36 -1.9151887508496218e-01 -2.6038253331120482e+00 -1.5631763792038542e-01 + 37 -5.4308678357699085e+00 3.1890361709539681e+00 -2.4512813444078403e+00 + 38 -4.8831911953854834e-01 -2.0911382434426233e+00 1.0263989663650521e+00 + 39 2.9583081381556897e-01 1.3064497582436145e+00 1.7854366483768509e+00 + 40 6.5759007584467497e+00 -3.2841132464413572e+00 -2.5014634020295063e+00 + 41 -7.4523257690304801e-01 -3.7773029542989391e+00 -3.6767020418412921e-01 + 42 -6.1312327154342396e+00 -1.5912197837133117e+00 -1.1855962370568189e-01 + 43 -7.1437588001434169e-02 -9.3031888107187211e+00 5.2754511162513296e-01 + 44 5.4932170480545217e+00 -3.9860368619527629e+00 1.7314892119390326e+00 + 45 -1.9946430535013895e+00 1.3671229931632587e+00 -4.6232127582616194e+00 + 46 -6.8496202690010577e-01 -2.7270551316211842e+00 7.9433814991520117e+00 + 47 3.2988872027001999e+00 2.5435438106820394e+00 6.4538031712204589e+00 + 48 2.9832582841622712e+00 1.1528571177955873e+00 -1.1771929693341157e+00 + 49 -6.0727927862320437e+00 -5.9562388562177775e+00 -6.5628478152085119e+00 + 50 -4.0304268005425916e+00 2.1299026394284661e+00 2.7736841705602946e+00 + 51 -2.3362097823934547e+00 3.2446508481241834e+00 6.0973333873913846e+00 + 52 6.6121228820666840e+00 -4.7286493145040840e+00 7.0211430066607825e+00 + 53 3.4705860716774821e+00 4.1400084168419884e+00 2.5096243926436443e+00 + 54 4.2357967515728950e-01 9.2785557547274899e-01 2.5722948535958462e-01 + 55 6.9092597174733328e-01 -4.3884673023252585e+00 -4.6957721500748519e+00 + 56 -1.6865429201680642e+00 3.5369692022565093e+00 -1.8052965931311840e+00 + 57 4.3961939657668192e-01 -2.8887423850093139e+00 -5.7296796525048743e-01 + 58 3.7570134025583659e+00 5.5027352242578065e-01 1.0958464933342578e+00 + 59 4.8450622687030140e+00 8.7301037576119778e-01 -2.9627442358410301e+00 + 60 -3.0352399103260401e+00 -5.5756624285612242e+00 -3.9845128251408610e+00 + 61 -1.4986666784757698e+00 3.0715079180009073e+00 -1.9202063976752488e+00 + 62 -3.4612601703739707e+00 5.2654166486564113e+00 -2.8054760695983396e+00 + 63 9.0463322673910671e+00 -1.4402000114087783e+00 -3.3926224071546960e+00 + 64 5.8257019271111208e+00 5.7499622015090264e+00 6.1760642521047480e+00 + 65 1.4101084499624945e+00 1.7371804088545499e+00 -1.6213174412210793e+00 + 66 -5.8399142482199569e+00 -1.1232412828534901e+00 -1.1499478454746328e+00 + 67 8.7634281400133751e-01 3.3470924205892656e+00 -8.1366156642163534e-01 + 68 1.6618348954343116e+00 1.3267230795340468e+00 -4.9613186302807328e+00 + 69 -9.5068329765370096e-01 -5.8237800850819186e+00 6.4731385586130286e-01 + 70 -4.5001292021631656e-01 4.9457441409188236e+00 1.9456461634789957e+00 + 71 -4.3052102443919482e+00 -4.5636488830760964e+00 1.5724677428330975e+00 + 72 1.5449878373123589e+00 2.4590982230198031e+00 -3.1390852730039280e+00 + 73 -4.6045449943310741e+00 -3.9440808098823101e+00 -4.6700755874078279e+00 + 74 3.7147697382419370e-01 -4.8285079070941711e-01 -3.6890671668077526e+00 + 75 3.8716570366709511e+00 -7.4579362411464762e+00 2.6984541425925879e+00 + 76 -5.6224994178131347e+00 -6.2110127059235003e+00 -6.7476211894063756e+00 + 77 3.1500132936973770e-02 7.0601764306126320e+00 -2.0944606590553616e+00 + 78 -2.3637150235790321e+00 5.8159045954962370e+00 9.2704917537072240e-01 + 79 -2.6728293943632591e+00 7.5552531622542647e+00 -4.8983926692928126e+00 + 80 2.6753525054677341e+00 -5.0623527488428222e-01 7.8939421082827224e+00 + 81 5.6999696634920971e+00 4.7279269674034552e+00 -4.4920700577051331e+00 + 82 -4.9787999902374329e+00 4.0981651408694910e+00 3.2088541364653573e+00 + 83 -1.6213391901712770e+00 -4.2635561713516665e+00 -9.7236351460331327e-01 + 84 -5.1758925760643839e+00 5.9036888087723627e+00 5.9897804863834434e+00 + 85 4.2475360018694719e-01 -1.5120403153751587e+00 -7.5118946585359421e+00 + 86 -8.4723991427859175e+00 5.8591586936796514e+00 -5.7220550448277363e+00 + 87 3.4936529015452691e+00 5.3887932178421707e+00 1.6618586990387330e+00 + 88 1.8397684085287699e-01 -4.7956123656855953e-01 -2.0248730631499217e+00 + 89 1.2740119839669910e+00 -1.9562152526426526e+00 4.6010648854406986e+00 + 90 -8.1088651153479241e-01 9.4981098330251235e-01 1.5857688839887580e+00 + 91 2.9237941762953805e+00 -2.0287483220569071e+00 2.7576412015032403e+00 + 92 -1.9423484320868498e+00 7.6700165963418865e-01 9.7032907448379326e+00 + 93 -3.0301266998673446e+00 3.3988629573493712e+00 -6.0790525480058024e+00 + 94 -1.9710732697574938e+00 2.6918587726714907e+00 -1.5068617145526619e+00 + 95 2.8596379254928421e+00 6.6388605559367853e-01 1.0001582081953513e+00 + 96 -1.2599066151315779e+00 -1.6716649508562664e+00 1.4607750060248836e+00 + 97 5.2650618358415588e+00 -6.0531728072803253e+00 6.8677797616117182e+00 + 98 2.8452772301515288e+00 5.6278916247943900e-01 -4.0654825176947940e-01 + 99 2.7601000342468502e+00 -5.8880962871766549e+00 2.6779862817975988e+00 + 100 -1.9151887508492124e-01 -2.6038253331120451e+00 -1.5631763792033387e-01 + 101 -5.4308678357699431e+00 3.1890361709539978e+00 -2.4512813444078665e+00 + 102 -4.8831911953855472e-01 -2.0911382434426278e+00 1.0263989663650606e+00 + 103 2.9583081381555676e-01 1.3064497582436023e+00 1.7854366483768360e+00 + 104 6.5759007584467266e+00 -3.2841132464413563e+00 -2.5014634020294988e+00 + 105 -7.4523257690308686e-01 -3.7773029542989343e+00 -3.6767020418418211e-01 + 106 -6.1312327154342698e+00 -1.5912197837132944e+00 -1.1855962370567052e-01 + 107 -7.1437588001479924e-02 -9.3031888107186997e+00 5.2754511162503914e-01 + 108 5.4932170480545004e+00 -3.9860368619527651e+00 1.7314892119390373e+00 + 109 -1.9946430535013113e+00 1.3671229931632198e+00 -4.6232127582615803e+00 + 110 -6.8496202690018182e-01 -2.7270551316212486e+00 7.9433814991520961e+00 + 111 3.2988872027002292e+00 2.5435438106820754e+00 6.4538031712204766e+00 + 112 2.9832582841622455e+00 1.1528571177956000e+00 -1.1771929693340835e+00 + 113 -6.0727927862320499e+00 -5.9562388562177873e+00 -6.5628478152085226e+00 + 114 -4.0304268005425925e+00 2.1299026394284701e+00 2.7736841705602981e+00 + 115 -2.3362097823934018e+00 3.2446508481241585e+00 6.0973333873913882e+00 + 116 6.6121228820667737e+00 -4.7286493145041346e+00 7.0211430066608598e+00 + 117 3.4705860716774479e+00 4.1400084168419946e+00 2.5096243926436532e+00 + 118 4.2357967515728706e-01 9.2785557547274511e-01 2.5722948535958162e-01 + 119 6.9092597174732118e-01 -4.3884673023252416e+00 -4.6957721500748546e+00 + 120 -1.6865429201680509e+00 3.5369692022564783e+00 -1.8052965931311662e+00 + 121 4.3961939657668664e-01 -2.8887423850093121e+00 -5.7296796525048810e-01 + 122 3.7570134025583277e+00 5.5027352242581618e-01 1.0958464933342473e+00 + 123 4.8450622687031748e+00 8.7301037576130136e-01 -2.9627442358410718e+00 + 124 -3.0352399103261227e+00 -5.5756624285612313e+00 -3.9845128251408641e+00 + 125 -1.4986666784757363e+00 3.0715079180009353e+00 -1.9202063976752926e+00 + 126 -3.4612601703739747e+00 5.2654166486564176e+00 -2.8054760695983476e+00 + 127 9.0463322673909925e+00 -1.4402000114088049e+00 -3.3926224071546933e+00 + 128 5.8257019271111385e+00 5.7499622015090441e+00 6.1760642521047737e+00 + 129 1.4101084499624534e+00 1.7371804088545049e+00 -1.6213174412210309e+00 + 130 -5.8399142482199737e+00 -1.1232412828535170e+00 -1.1499478454746650e+00 + 131 8.7634281400135128e-01 3.3470924205892754e+00 -8.1366156642164844e-01 + 132 1.6618348954343223e+00 1.3267230795340734e+00 -4.9613186302807142e+00 + 133 -9.5068329765370629e-01 -5.8237800850819088e+00 6.4731385586130863e-01 + 134 -4.5001292021624067e-01 4.9457441409188281e+00 1.9456461634790669e+00 + 135 -4.3052102443919820e+00 -4.5636488830760884e+00 1.5724677428330815e+00 + 136 1.5449878373122401e+00 2.4590982230198803e+00 -3.1390852730039502e+00 + 137 -4.6045449943310786e+00 -3.9440808098823172e+00 -4.6700755874078350e+00 + 138 3.7147697382417788e-01 -4.8285079070949538e-01 -3.6890671668077770e+00 + 139 3.8716570366709662e+00 -7.4579362411464789e+00 2.6984541425926039e+00 + 140 -5.6224994178131524e+00 -6.2110127059234923e+00 -6.7476211894063933e+00 + 141 3.1500132936956658e-02 7.0601764306126444e+00 -2.0944606590553514e+00 + 142 -2.3637150235790285e+00 5.8159045954963942e+00 9.2704917537068410e-01 + 143 -2.6728293943632346e+00 7.5552531622542176e+00 -4.8983926692927744e+00 + 144 2.6753525054676777e+00 -5.0623527488432618e-01 7.8939421082828236e+00 + 145 5.6999696634920909e+00 4.7279269674034268e+00 -4.4920700577051145e+00 + 146 -4.9787999902374720e+00 4.0981651408695159e+00 3.2088541364653769e+00 + 147 -1.6213391901711944e+00 -4.2635561713517127e+00 -9.7236351460331005e-01 + 148 -5.1758925760643901e+00 5.9036888087723742e+00 5.9897804863834399e+00 + 149 4.2475360018696456e-01 -1.5120403153751769e+00 -7.5118946585359945e+00 + 150 -8.4723991427858021e+00 5.8591586936796105e+00 -5.7220550448276448e+00 + 151 3.4936529015452695e+00 5.3887932178421245e+00 1.6618586990386814e+00 + 152 1.8397684085289256e-01 -4.7956123656857275e-01 -2.0248730631499354e+00 + 153 1.2740119839669732e+00 -1.9562152526426315e+00 4.6010648854407039e+00 + 154 -8.1088651153479885e-01 9.4981098330247371e-01 1.5857688839887165e+00 + 155 2.9237941762953730e+00 -2.0287483220569480e+00 2.7576412015032266e+00 + 156 -1.9423484320867530e+00 7.6700165963413269e-01 9.7032907448379966e+00 + 157 -3.0301266998673473e+00 3.3988629573493685e+00 -6.0790525480057864e+00 + 158 -1.9710732697574673e+00 2.6918587726715124e+00 -1.5068617145526344e+00 + 159 2.8596379254928128e+00 6.6388605559371483e-01 1.0001582081953824e+00 + 160 -1.2599066151316147e+00 -1.6716649508563088e+00 1.4607750060249303e+00 + 161 5.2650618358415553e+00 -6.0531728072803341e+00 6.8677797616117280e+00 + 162 2.8452772301515159e+00 5.6278916247941968e-01 -4.0654825176945431e-01 + 163 2.7601000342468334e+00 -5.8880962871766469e+00 2.6779862817975615e+00 + 164 -1.9151887508495447e-01 -2.6038253331119967e+00 -1.5631763792036044e-01 + 165 -5.4308678357699263e+00 3.1890361709539787e+00 -2.4512813444078483e+00 + 166 -4.8831911953854296e-01 -2.0911382434426180e+00 1.0263989663650475e+00 + 167 2.9583081381557141e-01 1.3064497582436205e+00 1.7854366483768458e+00 + 168 6.5759007584467666e+00 -3.2841132464414158e+00 -2.5014634020295765e+00 + 169 -7.4523257690304012e-01 -3.7773029542989214e+00 -3.6767020418412721e-01 + 170 -6.1312327154342663e+00 -1.5912197837133537e+00 -1.1855962370571882e-01 + 171 -7.1437588001445965e-02 -9.3031888107187068e+00 5.2754511162511697e-01 + 172 5.4932170480545635e+00 -3.9860368619528423e+00 1.7314892119390801e+00 + 173 -1.9946430535013948e+00 1.3671229931632465e+00 -4.6232127582616149e+00 + 174 -6.8496202690001984e-01 -2.7270551316211127e+00 7.9433814991520046e+00 + 175 3.2988872027002070e+00 2.5435438106820452e+00 6.4538031712204509e+00 + 176 2.9832582841622548e+00 1.1528571177956544e+00 -1.1771929693340815e+00 + 177 -6.0727927862320792e+00 -5.9562388562178219e+00 -6.5628478152085759e+00 + 178 -4.0304268005425792e+00 2.1299026394284679e+00 2.7736841705602893e+00 + 179 -2.3362097823934898e+00 3.2446508481242033e+00 6.0973333873914299e+00 + 180 6.6121228820666635e+00 -4.7286493145040209e+00 7.0211430066607718e+00 + 181 3.4705860716775057e+00 4.1400084168420239e+00 2.5096243926437127e+00 + 182 4.2357967515729050e-01 9.2785557547273534e-01 2.5722948535958101e-01 + 183 6.9092597174730619e-01 -4.3884673023252452e+00 -4.6957721500748217e+00 + 184 -1.6865429201680540e+00 3.5369692022564840e+00 -1.8052965931311715e+00 + 185 4.3961939657667709e-01 -2.8887423850093583e+00 -5.7296796525051796e-01 + 186 3.7570134025583464e+00 5.5027352242581329e-01 1.0958464933342382e+00 + 187 4.8450622687029874e+00 8.7301037576109541e-01 -2.9627442358409946e+00 + 188 -3.0352399103260255e+00 -5.5756624285611940e+00 -3.9845128251408686e+00 + 189 -1.4986666784757705e+00 3.0715079180009308e+00 -1.9202063976752652e+00 + 190 -3.4612601703740626e+00 5.2654166486565011e+00 -2.8054760695984231e+00 + 191 9.0463322673910387e+00 -1.4402000114087514e+00 -3.3926224071546280e+00 + 192 5.8257019271111021e+00 5.7499622015090095e+00 6.1760642521047258e+00 + 193 1.4101084499624608e+00 1.7371804088545164e+00 -1.6213174412210414e+00 + 194 -5.8399142482199755e+00 -1.1232412828535212e+00 -1.1499478454746739e+00 + 195 8.7634281400136826e-01 3.3470924205892794e+00 -8.1366156642166787e-01 + 196 1.6618348954342919e+00 1.3267230795340308e+00 -4.9613186302807337e+00 + 197 -9.5068329765370507e-01 -5.8237800850819008e+00 6.4731385586130585e-01 + 198 -4.5001292021626715e-01 4.9457441409188689e+00 1.9456461634790359e+00 + 199 -4.3052102443918923e+00 -4.5636488830760849e+00 1.5724677428330582e+00 + 200 1.5449878373123116e+00 2.4590982230198688e+00 -3.1390852730039280e+00 + 201 -4.6045449943310741e+00 -3.9440808098823092e+00 -4.6700755874078261e+00 + 202 3.7147697382411032e-01 -4.8285079070955383e-01 -3.6890671668077881e+00 + 203 3.8716570366709511e+00 -7.4579362411464674e+00 2.6984541425925892e+00 + 204 -5.6224994178132013e+00 -6.2110127059235545e+00 -6.7476211894064360e+00 + 205 3.1500132936960558e-02 7.0601764306126391e+00 -2.0944606590553407e+00 + 206 -2.3637150235789921e+00 5.8159045954964084e+00 9.2704917537071352e-01 + 207 -2.6728293943632542e+00 7.5552531622542540e+00 -4.8983926692928019e+00 + 208 2.6753525054677469e+00 -5.0623527488422482e-01 7.8939421082828281e+00 + 209 5.6999696634921291e+00 4.7279269674034738e+00 -4.4920700577051562e+00 + 210 -4.9787999902374684e+00 4.0981651408695106e+00 3.2088541364653715e+00 + 211 -1.6213391901712724e+00 -4.2635561713517145e+00 -9.7236351460333603e-01 + 212 -5.1758925760643830e+00 5.9036888087723653e+00 5.9897804863834381e+00 + 213 4.2475360018697278e-01 -1.5120403153751836e+00 -7.5118946585359749e+00 + 214 -8.4723991427858589e+00 5.8591586936796665e+00 -5.7220550448277150e+00 + 215 3.4936529015452913e+00 5.3887932178421645e+00 1.6618586990387143e+00 + 216 1.8397684085288563e-01 -4.7956123656856331e-01 -2.0248730631499283e+00 + 217 1.2740119839669883e+00 -1.9562152526426537e+00 4.6010648854406986e+00 + 218 -8.1088651153480396e-01 9.4981098330248848e-01 1.5857688839887434e+00 + 219 2.9237941762953339e+00 -2.0287483220569635e+00 2.7576412015032186e+00 + 220 -1.9423484320867117e+00 7.6700165963408562e-01 9.7032907448379540e+00 + 221 -3.0301266998673344e+00 3.3988629573493538e+00 -6.0790525480057900e+00 + 222 -1.9710732697574636e+00 2.6918587726714938e+00 -1.5068617145526289e+00 + 223 2.8596379254928648e+00 6.6388605559370273e-01 1.0001582081953790e+00 + 224 -1.2599066151316045e+00 -1.6716649508562935e+00 1.4607750060249154e+00 + 225 5.2650618358415464e+00 -6.0531728072803164e+00 6.8677797616117031e+00 + 226 2.8452772301515386e+00 5.6278916247941591e-01 -4.0654825176945270e-01 + 227 2.7601000342468498e+00 -5.8880962871766611e+00 2.6779862817975961e+00 + 228 -1.9151887508490981e-01 -2.6038253331119856e+00 -1.5631763792030609e-01 + 229 -5.4308678357699511e+00 3.1890361709539934e+00 -2.4512813444078612e+00 + 230 -4.8831911953854984e-01 -2.0911382434426251e+00 1.0263989663650557e+00 + 231 2.9583081381556320e-01 1.3064497582436116e+00 1.7854366483768354e+00 + 232 6.5759007584467382e+00 -3.2841132464414193e+00 -2.5014634020295694e+00 + 233 -7.4523257690308631e-01 -3.7773029542989258e+00 -3.6767020418418467e-01 + 234 -6.1312327154342894e+00 -1.5912197837133386e+00 -1.1855962370570818e-01 + 235 -7.1437588001492872e-02 -9.3031888107186891e+00 5.2754511162502227e-01 + 236 5.4932170480545430e+00 -3.9860368619528441e+00 1.7314892119390803e+00 + 237 -1.9946430535013142e+00 1.3671229931632154e+00 -4.6232127582615608e+00 + 238 -6.8496202690009744e-01 -2.7270551316211820e+00 7.9433814991520935e+00 + 239 3.2988872027002363e+00 2.5435438106820789e+00 6.4538031712204704e+00 + 240 2.9832582841622362e+00 1.1528571177956641e+00 -1.1771929693340462e+00 + 241 -6.0727927862320854e+00 -5.9562388562178352e+00 -6.5628478152085883e+00 + 242 -4.0304268005425721e+00 2.1299026394284692e+00 2.7736841705602875e+00 + 243 -2.3362097823934374e+00 3.2446508481241776e+00 6.0973333873914353e+00 + 244 6.6121228820667399e+00 -4.7286493145040733e+00 7.0211430066608385e+00 + 245 3.4705860716774652e+00 4.1400084168420435e+00 2.5096243926437278e+00 + 246 4.2357967515728162e-01 9.2785557547273401e-01 2.5722948535957330e-01 + 247 6.9092597174729831e-01 -4.3884673023252470e+00 -4.6957721500748297e+00 + 248 -1.6865429201680422e+00 3.5369692022564601e+00 -1.8052965931311555e+00 + 249 4.3961939657668897e-01 -2.8887423850093570e+00 -5.7296796525051763e-01 + 250 3.7570134025583206e+00 5.5027352242584893e-01 1.0958464933342245e+00 + 251 4.8450622687031517e+00 8.7301037576121032e-01 -2.9627442358410292e+00 + 252 -3.0352399103261058e+00 -5.5756624285611966e+00 -3.9845128251408668e+00 + 253 -1.4986666784757416e+00 3.0715079180009628e+00 -1.9202063976753083e+00 + 254 -3.4612601703740657e+00 5.2654166486565055e+00 -2.8054760695984311e+00 + 255 9.0463322673909605e+00 -1.4402000114087883e+00 -3.3926224071546374e+00 + 256 5.8257019271111172e+00 5.7499622015090237e+00 6.1760642521047506e+00 + 257 1.4101084499624821e+00 1.7371804088545320e+00 -1.6213174412210622e+00 + 258 -5.8399142482199720e+00 -1.1232412828535363e+00 -1.1499478454746668e+00 + 259 8.7634281400131031e-01 3.3470924205892638e+00 -8.1366156642160625e-01 + 260 1.6618348954343440e+00 1.3267230795340927e+00 -4.9613186302806929e+00 + 261 -9.5068329765371196e-01 -5.8237800850819008e+00 6.4731385586131096e-01 + 262 -4.5001292021624006e-01 4.9457441409188165e+00 1.9456461634790361e+00 + 263 -4.3052102443920655e+00 -4.5636488830761079e+00 1.5724677428331033e+00 + 264 1.5449878373123045e+00 2.4590982230197711e+00 -3.1390852730039596e+00 + 265 -4.6045449943310590e+00 -3.9440808098822986e+00 -4.6700755874078190e+00 + 266 3.7147697382421191e-01 -4.8285079070938253e-01 -3.6890671668078272e+00 + 267 3.8716570366710106e+00 -7.4579362411464922e+00 2.6984541425926230e+00 + 268 -5.6224994178131089e+00 -6.2110127059234665e+00 -6.7476211894063454e+00 + 269 3.1500132936923747e-02 7.0601764306126489e+00 -2.0944606590553865e+00 + 270 -2.3637150235789854e+00 5.8159045954962343e+00 9.2704917537076525e-01 + 271 -2.6728293943632391e+00 7.5552531622541936e+00 -4.8983926692927895e+00 + 272 2.6753525054677070e+00 -5.0623527488435160e-01 7.8939421082827304e+00 + 273 5.6999696634920456e+00 4.7279269674033984e+00 -4.4920700577050825e+00 + 274 -4.9787999902374587e+00 4.0981651408695194e+00 3.2088541364653747e+00 + 275 -1.6213391901711784e+00 -4.2635561713516665e+00 -9.7236351460323123e-01 + 276 -5.1758925760643768e+00 5.9036888087723671e+00 5.9897804863834461e+00 + 277 4.2475360018693203e-01 -1.5120403153751611e+00 -7.5118946585359998e+00 + 278 -8.4723991427858163e+00 5.8591586936795723e+00 -5.7220550448276324e+00 + 279 3.4936529015452158e+00 5.3887932178421147e+00 1.6618586990386937e+00 + 280 1.8397684085290614e-01 -4.7956123656858746e-01 -2.0248730631499305e+00 + 281 1.2740119839669295e+00 -1.9562152526425904e+00 4.6010648854406897e+00 + 282 -8.1088651153478086e-01 9.4981098330250702e-01 1.5857688839887112e+00 + 283 2.9237941762954396e+00 -2.0287483220568601e+00 2.7576412015032639e+00 + 284 -1.9423484320868234e+00 7.6700165963416189e-01 9.7032907448380499e+00 + 285 -3.0301266998673673e+00 3.3988629573493960e+00 -6.0790525480057918e+00 + 286 -1.9710732697575224e+00 2.6918587726715231e+00 -1.5068617145526926e+00 + 287 2.8596379254927800e+00 6.6388605559365599e-01 1.0001582081953235e+00 + 288 -1.2599066151315834e+00 -1.6716649508562769e+00 1.4607750060248932e+00 + 289 5.2650618358415393e+00 -6.0531728072803137e+00 6.8677797616117173e+00 + 290 2.8452772301515066e+00 5.6278916247943045e-01 -4.0654825176946702e-01 + 291 2.7601000342468001e+00 -5.8880962871766300e+00 2.6779862817975353e+00 + 292 -1.9151887508495458e-01 -2.6038253331120433e+00 -1.5631763792035228e-01 + 293 -5.4308678357698943e+00 3.1890361709539579e+00 -2.4512813444078385e+00 + 294 -4.8831911953853374e-01 -2.0911382434426065e+00 1.0263989663650335e+00 + 295 2.9583081381557258e-01 1.3064497582436179e+00 1.7854366483768653e+00 + 296 6.5759007584467710e+00 -3.2841132464413874e+00 -2.5014634020295454e+00 + 297 -7.4523257690301581e-01 -3.7773029542989440e+00 -3.6767020418409979e-01 + 298 -6.1312327154342841e+00 -1.5912197837134179e+00 -1.1855962370576735e-01 + 299 -7.1437588001370414e-02 -9.3031888107186909e+00 5.2754511162517459e-01 + 300 5.4932170480544942e+00 -3.9860368619527264e+00 1.7314892119389909e+00 + 301 -1.9946430535014457e+00 1.3671229931632713e+00 -4.6232127582616096e+00 + 302 -6.8496202690010877e-01 -2.7270551316211198e+00 7.9433814991521130e+00 + 303 3.2988872027001550e+00 2.5435438106820074e+00 6.4538031712204074e+00 + 304 2.9832582841622832e+00 1.1528571177955860e+00 -1.1771929693341221e+00 + 305 -6.0727927862320188e+00 -5.9562388562177242e+00 -6.5628478152084666e+00 + 306 -4.0304268005425739e+00 2.1299026394283915e+00 2.7736841705602342e+00 + 307 -2.3362097823934587e+00 3.2446508481241976e+00 6.0973333873914486e+00 + 308 6.6121228820666698e+00 -4.7286493145040485e+00 7.0211430066607754e+00 + 309 3.4705860716773902e+00 4.1400084168419946e+00 2.5096243926436350e+00 + 310 4.2357967515730982e-01 9.2785557547277886e-01 2.5722948535960299e-01 + 311 6.9092597174732806e-01 -4.3884673023252336e+00 -4.6957721500748990e+00 + 312 -1.6865429201680846e+00 3.5369692022565031e+00 -1.8052965931312008e+00 + 313 4.3961939657667753e-01 -2.8887423850093206e+00 -5.7296796525047766e-01 + 314 3.7570134025583668e+00 5.5027352242574279e-01 1.0958464933342584e+00 + 315 4.8450622687030931e+00 8.7301037576128449e-01 -2.9627442358410239e+00 + 316 -3.0352399103260499e+00 -5.5756624285612588e+00 -3.9845128251408717e+00 + 317 -1.4986666784757807e+00 3.0715079180009188e+00 -1.9202063976752237e+00 + 318 -3.4612601703738872e+00 5.2654166486563296e+00 -2.8054760695982797e+00 + 319 9.0463322673910156e+00 -1.4402000114088058e+00 -3.3926224071547022e+00 + 320 5.8257019271111492e+00 5.7499622015090619e+00 6.1760642521047746e+00 + 321 1.4101084499624930e+00 1.7371804088545482e+00 -1.6213174412210776e+00 + 322 -5.8399142482199764e+00 -1.1232412828535339e+00 -1.1499478454746686e+00 + 323 8.7634281400132608e-01 3.3470924205892665e+00 -8.1366156642162457e-01 + 324 1.6618348954343205e+00 1.3267230795340574e+00 -4.9613186302807080e+00 + 325 -9.5068329765370641e-01 -5.8237800850818982e+00 6.4731385586130263e-01 + 326 -4.5001292021627354e-01 4.9457441409188521e+00 1.9456461634790065e+00 + 327 -4.3052102443919802e+00 -4.5636488830761017e+00 1.5724677428330862e+00 + 328 1.5449878373123684e+00 2.4590982230197573e+00 -3.1390852730039471e+00 + 329 -4.6045449943310564e+00 -3.9440808098822910e+00 -4.6700755874078128e+00 + 330 3.7147697382415185e-01 -4.8285079070942744e-01 -3.6890671668078241e+00 + 331 3.8716570366710017e+00 -7.4579362411464851e+00 2.6984541425926141e+00 + 332 -5.6224994178131533e+00 -6.2110127059235163e+00 -6.7476211894063827e+00 + 333 3.1500132936925183e-02 7.0601764306126444e+00 -2.0944606590553865e+00 + 334 -2.3637150235789504e+00 5.8159045954962405e+00 9.2704917537079212e-01 + 335 -2.6728293943632542e+00 7.5552531622542229e+00 -4.8983926692928046e+00 + 336 2.6753525054677669e+00 -5.0623527488425835e-01 7.8939421082827224e+00 + 337 5.6999696634920856e+00 4.7279269674034463e+00 -4.4920700577051269e+00 + 338 -4.9787999902374551e+00 4.0981651408695221e+00 3.2088541364653778e+00 + 339 -1.6213391901712344e+00 -4.2635561713516585e+00 -9.7236351460324666e-01 + 340 -5.1758925760643697e+00 5.9036888087723565e+00 5.9897804863834354e+00 + 341 4.2475360018693609e-01 -1.5120403153751667e+00 -7.5118946585359909e+00 + 342 -8.4723991427858785e+00 5.8591586936796265e+00 -5.7220550448277079e+00 + 343 3.4936529015452273e+00 5.3887932178421618e+00 1.6618586990387230e+00 + 344 1.8397684085289956e-01 -4.7956123656857780e-01 -2.0248730631499239e+00 + 345 1.2740119839669390e+00 -1.9562152526426062e+00 4.6010648854406764e+00 + 346 -8.1088651153478553e-01 9.4981098330252334e-01 1.5857688839887387e+00 + 347 2.9237941762953992e+00 -2.0287483220568805e+00 2.7576412015032563e+00 + 348 -1.9423484320867914e+00 7.6700165963412470e-01 9.7032907448380126e+00 + 349 -3.0301266998673508e+00 3.3988629573493823e+00 -6.0790525480057935e+00 + 350 -1.9710732697575186e+00 2.6918587726715040e+00 -1.5068617145526872e+00 + 351 2.8596379254928315e+00 6.6388605559364489e-01 1.0001582081953193e+00 + 352 -1.2599066151315763e+00 -1.6716649508562649e+00 1.4607750060248825e+00 + 353 5.2650618358415358e+00 -6.0531728072803039e+00 6.8677797616117013e+00 + 354 2.8452772301515208e+00 5.6278916247943167e-01 -4.0654825176947129e-01 + 355 2.7601000342468276e+00 -5.8880962871766460e+00 2.6779862817975841e+00 + 356 -1.9151887508491444e-01 -2.6038253331120340e+00 -1.5631763792030451e-01 + 357 -5.4308678357699245e+00 3.1890361709539801e+00 -2.4512813444078616e+00 + 358 -4.8831911953854307e-01 -2.0911382434426167e+00 1.0263989663650450e+00 + 359 2.9583081381555965e-01 1.3064497582436063e+00 1.7854366483768507e+00 + 360 6.5759007584467506e+00 -3.2841132464413922e+00 -2.5014634020295325e+00 + 361 -7.4523257690305722e-01 -3.7773029542989423e+00 -3.6767020418415286e-01 + 362 -6.1312327154343169e+00 -1.5912197837133930e+00 -1.1855962370575777e-01 + 363 -7.1437588001404595e-02 -9.3031888107186678e+00 5.2754511162509421e-01 + 364 5.4932170480544711e+00 -3.9860368619527211e+00 1.7314892119389858e+00 + 365 -1.9946430535013675e+00 1.3671229931632347e+00 -4.6232127582615679e+00 + 366 -6.8496202690018337e-01 -2.7270551316211873e+00 7.9433814991521965e+00 + 367 3.2988872027001723e+00 2.5435438106820345e+00 6.4538031712204189e+00 + 368 2.9832582841622557e+00 1.1528571177956033e+00 -1.1771929693340897e+00 + 369 -6.0727927862320215e+00 -5.9562388562177313e+00 -6.5628478152084746e+00 + 370 -4.0304268005425694e+00 2.1299026394283858e+00 2.7736841705602271e+00 + 371 -2.3362097823934023e+00 3.2446508481241731e+00 6.0973333873914468e+00 + 372 6.6121228820667550e+00 -4.7286493145041018e+00 7.0211430066608349e+00 + 373 3.4705860716773431e+00 4.1400084168420124e+00 2.5096243926436417e+00 + 374 4.2357967515730849e-01 9.2785557547278052e-01 2.5722948535960155e-01 + 375 6.9092597174731007e-01 -4.3884673023252097e+00 -4.6957721500749070e+00 + 376 -1.6865429201680713e+00 3.5369692022564734e+00 -1.8052965931311837e+00 + 377 4.3961939657668581e-01 -2.8887423850093219e+00 -5.7296796525047600e-01 + 378 3.7570134025583304e+00 5.5027352242577721e-01 1.0958464933342462e+00 + 379 4.8450622687032530e+00 8.7301037576138063e-01 -2.9627442358410687e+00 + 380 -3.0352399103261356e+00 -5.5756624285612642e+00 -3.9845128251408739e+00 + 381 -1.4986666784757519e+00 3.0715079180009477e+00 -1.9202063976752695e+00 + 382 -3.4612601703738868e+00 5.2654166486563332e+00 -2.8054760695982841e+00 + 383 9.0463322673909374e+00 -1.4402000114088291e+00 -3.3926224071546991e+00 + 384 5.8257019271111679e+00 5.7499622015090797e+00 6.1760642521048039e+00 + 385 1.4101084499624525e+00 1.7371804088545033e+00 -1.6213174412210296e+00 + 386 -5.8399142482199862e+00 -1.1232412828535530e+00 -1.1499478454746939e+00 + 387 8.7634281400133762e-01 3.3470924205892811e+00 -8.1366156642163467e-01 + 388 1.6618348954343189e+00 1.3267230795340708e+00 -4.9613186302806893e+00 + 389 -9.5068329765370574e-01 -5.8237800850818857e+00 6.4731385586130419e-01 + 390 -4.5001292021620803e-01 4.9457441409188609e+00 1.9456461634790638e+00 + 391 -4.3052102443920148e+00 -4.5636488830760928e+00 1.5724677428330669e+00 + 392 1.5449878373122630e+00 2.4590982230198328e+00 -3.1390852730039636e+00 + 393 -4.6045449943310599e+00 -3.9440808098822973e+00 -4.6700755874078190e+00 + 394 3.7147697382413564e-01 -4.8285079070951542e-01 -3.6890671668078552e+00 + 395 3.8716570366710150e+00 -7.4579362411464905e+00 2.6984541425926283e+00 + 396 -5.6224994178131684e+00 -6.2110127059235083e+00 -6.7476211894064004e+00 + 397 3.1500132936903361e-02 7.0601764306126622e+00 -2.0944606590553727e+00 + 398 -2.3637150235789628e+00 5.8159045954964084e+00 9.2704917537075482e-01 + 399 -2.6728293943632360e+00 7.5552531622541848e+00 -4.8983926692927824e+00 + 400 2.6753525054677088e+00 -5.0623527488430753e-01 7.8939421082828236e+00 + 401 5.6999696634920838e+00 4.7279269674034206e+00 -4.4920700577051109e+00 + 402 -4.9787999902374853e+00 4.0981651408695390e+00 3.2088541364653889e+00 + 403 -1.6213391901711742e+00 -4.2635561713517065e+00 -9.7236351460324078e-01 + 404 -5.1758925760643617e+00 5.9036888087723556e+00 5.9897804863834248e+00 + 405 4.2475360018695274e-01 -1.5120403153751805e+00 -7.5118946585360309e+00 + 406 -8.4723991427857683e+00 5.8591586936795927e+00 -5.7220550448276235e+00 + 407 3.4936529015452371e+00 5.3887932178421076e+00 1.6618586990386719e+00 + 408 1.8397684085291077e-01 -4.7956123656858829e-01 -2.0248730631499336e+00 + 409 1.2740119839669277e+00 -1.9562152526425909e+00 4.6010648854406906e+00 + 410 -8.1088651153479041e-01 9.4981098330248481e-01 1.5857688839886941e+00 + 411 2.9237941762953978e+00 -2.0287483220569191e+00 2.7576412015032483e+00 + 412 -1.9423484320866864e+00 7.6700165963406364e-01 9.7032907448380747e+00 + 413 -3.0301266998673588e+00 3.3988629573493836e+00 -6.0790525480057784e+00 + 414 -1.9710732697574922e+00 2.6918587726715275e+00 -1.5068617145526606e+00 + 415 2.8596379254928053e+00 6.6388605559367742e-01 1.0001582081953477e+00 + 416 -1.2599066151316127e+00 -1.6716649508563064e+00 1.4607750060249283e+00 + 417 5.2650618358415322e+00 -6.0531728072803128e+00 6.8677797616117084e+00 + 418 2.8452772301515101e+00 5.6278916247941135e-01 -4.0654825176944531e-01 + 419 2.7601000342468089e+00 -5.8880962871766425e+00 2.6779862817975424e+00 + 420 -1.9151887508494253e-01 -2.6038253331119847e+00 -1.5631763792032466e-01 + 421 -5.4308678357699103e+00 3.1890361709539627e+00 -2.4512813444078398e+00 + 422 -4.8831911953852797e-01 -2.0911382434426020e+00 1.0263989663650284e+00 + 423 2.9583081381557613e-01 1.3064497582436265e+00 1.7854366483768651e+00 + 424 6.5759007584467728e+00 -3.2841132464414398e+00 -2.5014634020296111e+00 + 425 -7.4523257690300748e-01 -3.7773029542989298e+00 -3.6767020418409530e-01 + 426 -6.1312327154343080e+00 -1.5912197837134572e+00 -1.1855962370580690e-01 + 427 -7.1437588001371552e-02 -9.3031888107186891e+00 5.2754511162517204e-01 + 428 5.4932170480545333e+00 -3.9860368619528117e+00 1.7314892119390457e+00 + 429 -1.9946430535014565e+00 1.3671229931632738e+00 -4.6232127582616211e+00 + 430 -6.8496202690002050e-01 -2.7270551316210470e+00 7.9433814991521041e+00 + 431 3.2988872027001621e+00 2.5435438106820136e+00 6.4538031712204020e+00 + 432 2.9832582841622699e+00 1.1528571177956566e+00 -1.1771929693340877e+00 + 433 -6.0727927862320508e+00 -5.9562388562177730e+00 -6.5628478152085341e+00 + 434 -4.0304268005425508e+00 2.1299026394283942e+00 2.7736841705602284e+00 + 435 -2.3362097823934858e+00 3.2446508481242029e+00 6.0973333873914832e+00 + 436 6.6121228820666458e+00 -4.7286493145039872e+00 7.0211430066607585e+00 + 437 3.4705860716774093e+00 4.1400084168420399e+00 2.5096243926437141e+00 + 438 4.2357967515730749e-01 9.2785557547275888e-01 2.5722948535959472e-01 + 439 6.9092597174730430e-01 -4.3884673023252345e+00 -4.6957721500748741e+00 + 440 -1.6865429201680737e+00 3.5369692022564805e+00 -1.8052965931311884e+00 + 441 4.3961939657667570e-01 -2.8887423850093761e+00 -5.7296796525051241e-01 + 442 3.7570134025583579e+00 5.5027352242577710e-01 1.0958464933342291e+00 + 443 4.8450622687030620e+00 8.7301037576117979e-01 -2.9627442358409883e+00 + 444 -3.0352399103260317e+00 -5.5756624285612162e+00 -3.9845128251408619e+00 + 445 -1.4986666784757814e+00 3.0715079180009548e+00 -1.9202063976752319e+00 + 446 -3.4612601703739747e+00 5.2654166486564131e+00 -2.8054760695983596e+00 + 447 9.0463322673909907e+00 -1.4402000114087794e+00 -3.3926224071546360e+00 + 448 5.8257019271111217e+00 5.7499622015090361e+00 6.1760642521047426e+00 + 449 1.4101084499624597e+00 1.7371804088545151e+00 -1.6213174412210403e+00 + 450 -5.8399142482199826e+00 -1.1232412828535623e+00 -1.1499478454747027e+00 + 451 8.7634281400135128e-01 3.3470924205892825e+00 -8.1366156642165033e-01 + 452 1.6618348954342974e+00 1.3267230795340375e+00 -4.9613186302807062e+00 + 453 -9.5068329765371173e-01 -5.8237800850818742e+00 6.4731385586130530e-01 + 454 -4.5001292021623840e-01 4.9457441409188965e+00 1.9456461634790305e+00 + 455 -4.3052102443919233e+00 -4.5636488830760875e+00 1.5724677428330425e+00 + 456 1.5449878373123287e+00 2.4590982230198164e+00 -3.1390852730039471e+00 + 457 -4.6045449943310555e+00 -3.9440808098822906e+00 -4.6700755874078110e+00 + 458 3.7147697382405820e-01 -4.8285079070957626e-01 -3.6890671668078694e+00 + 459 3.8716570366710061e+00 -7.4579362411464825e+00 2.6984541425926185e+00 + 460 -5.6224994178132075e+00 -6.2110127059235563e+00 -6.7476211894064324e+00 + 461 3.1500132936904394e-02 7.0601764306126551e+00 -2.0944606590553683e+00 + 462 -2.3637150235788997e+00 5.8159045954964208e+00 9.2704917537079956e-01 + 463 -2.6728293943632488e+00 7.5552531622542132e+00 -4.8983926692927993e+00 + 464 2.6753525054677629e+00 -5.0623527488421971e-01 7.8939421082828227e+00 + 465 5.6999696634921175e+00 4.7279269674034632e+00 -4.4920700577051491e+00 + 466 -4.9787999902374853e+00 4.0981651408695390e+00 3.2088541364653929e+00 + 467 -1.6213391901712317e+00 -4.2635561713516923e+00 -9.7236351460325832e-01 + 468 -5.1758925760643590e+00 5.9036888087723547e+00 5.9897804863834283e+00 + 469 4.2475360018695851e-01 -1.5120403153751887e+00 -7.5118946585360202e+00 + 470 -8.4723991427858198e+00 5.8591586936796345e+00 -5.7220550448276848e+00 + 471 3.4936529015452535e+00 5.3887932178421414e+00 1.6618586990386996e+00 + 472 1.8397684085290258e-01 -4.7956123656857802e-01 -2.0248730631499252e+00 + 473 1.2740119839669375e+00 -1.9562152526426058e+00 4.6010648854406782e+00 + 474 -8.1088651153479008e-01 9.4981098330248936e-01 1.5857688839887156e+00 + 475 2.9237941762953636e+00 -2.0287483220569400e+00 2.7576412015032501e+00 + 476 -1.9423484320866595e+00 7.6700165963402811e-01 9.7032907448380463e+00 + 477 -3.0301266998673562e+00 3.3988629573493827e+00 -6.0790525480057811e+00 + 478 -1.9710732697574942e+00 2.6918587726715151e+00 -1.5068617145526599e+00 + 479 2.8596379254928510e+00 6.6388605559366176e-01 1.0001582081953388e+00 + 480 -1.2599066151316027e+00 -1.6716649508562909e+00 1.4607750060249132e+00 + 481 5.2650618358415304e+00 -6.0531728072803013e+00 6.8677797616116942e+00 + 482 2.8452772301515323e+00 5.6278916247940747e-01 -4.0654825176944437e-01 + 483 2.7601000342468427e+00 -5.8880962871766620e+00 2.6779862817975988e+00 + 484 -1.9151887508489973e-01 -2.6038253331119732e+00 -1.5631763792027364e-01 + 485 -5.4308678357699458e+00 3.1890361709539921e+00 -2.4512813444078692e+00 + 486 -4.8831911953853724e-01 -2.0911382434426127e+00 1.0263989663650404e+00 + 487 2.9583081381556153e-01 1.3064497582436110e+00 1.7854366483768467e+00 + 488 6.5759007584467559e+00 -3.2841132464414446e+00 -2.5014634020295974e+00 + 489 -7.4523257690305023e-01 -3.7773029542989289e+00 -3.6767020418414947e-01 + 490 -6.1312327154343400e+00 -1.5912197837134316e+00 -1.1855962370579468e-01 + 491 -7.1437588001410285e-02 -9.3031888107186607e+00 5.2754511162508533e-01 + 492 5.4932170480545075e+00 -3.9860368619527939e+00 1.7314892119390288e+00 + 493 -1.9946430535013788e+00 1.3671229931632261e+00 -4.6232127582615652e+00 + 494 -6.8496202690009644e-01 -2.7270551316211180e+00 7.9433814991521929e+00 + 495 3.2988872027001812e+00 2.5435438106820385e+00 6.4538031712204118e+00 + 496 2.9832582841622437e+00 1.1528571177956686e+00 -1.1771929693340504e+00 + 497 -6.0727927862320561e+00 -5.9562388562177819e+00 -6.5628478152085421e+00 + 498 -4.0304268005425445e+00 2.1299026394283875e+00 2.7736841705602195e+00 + 499 -2.3362097823934316e+00 3.2446508481241807e+00 6.0973333873914815e+00 + 500 6.6121228820667195e+00 -4.7286493145040280e+00 7.0211430066608118e+00 + 501 3.4705860716773675e+00 4.1400084168420586e+00 2.5096243926437238e+00 + 502 4.2357967515730505e-01 9.2785557547276187e-01 2.5722948535959261e-01 + 503 6.9092597174729276e-01 -4.3884673023252168e+00 -4.6957721500748875e+00 + 504 -1.6865429201680671e+00 3.5369692022564592e+00 -1.8052965931311771e+00 + 505 4.3961939657668192e-01 -2.8887423850093774e+00 -5.7296796525051119e-01 + 506 3.7570134025583219e+00 5.5027352242580696e-01 1.0958464933342265e+00 + 507 4.8450622687032290e+00 8.7301037576129070e-01 -2.9627442358410261e+00 + 508 -3.0352399103261072e+00 -5.5756624285612277e+00 -3.9845128251408530e+00 + 509 -1.4986666784757479e+00 3.0715079180009810e+00 -1.9202063976752817e+00 + 510 -3.4612601703739792e+00 5.2654166486564211e+00 -2.8054760695983689e+00 + 511 9.0463322673909019e+00 -1.4402000114088067e+00 -3.3926224071546316e+00 + 512 5.8257019271111394e+00 5.7499622015090530e+00 6.1760642521047702e+00 ... diff --git a/unittest/force-styles/tests/manybody-pair-bop_save.yaml b/unittest/force-styles/tests/manybody-pair-bop_save.yaml index 77388eb6d6..a409cc6a18 100644 --- a/unittest/force-styles/tests/manybody-pair-bop_save.yaml +++ b/unittest/force-styles/tests/manybody-pair-bop_save.yaml @@ -1,7 +1,7 @@ --- -lammps_version: 8 Apr 2021 +lammps_version: 4 May 2022 tags: slow, unstable -date_generated: Wed May 5 11:50:24 2021 +date_generated: Fri May 27 17:36:37 2022 epsilon: 2e-11 prerequisites: ! | pair bop @@ -535,521 +535,521 @@ init_forces: ! |2 510 -2.2749371215520973e+00 3.3600739184147281e+00 -2.2482793489540440e+00 511 5.5276560306465985e+00 -1.7222471161905775e+00 -2.0146673282516816e+00 512 4.5674510924053244e+00 4.8005511894034880e+00 3.9347170870249073e+00 -run_vdwl: -1148.282038612608 +run_vdwl: -1148.085978939542 run_coul: 0 run_stress: ! |2- - 4.0607716458773768e+02 4.1990275279117287e+02 4.3189008174024184e+02 -1.5062607937984635e+02 2.6526098686927287e+02 9.4584979764475761e+01 + 4.0653370543801509e+02 4.2033870846285419e+02 4.3236415621179896e+02 -1.5065757455794261e+02 2.6546325857473971e+02 9.4558303537896379e+01 run_forces: ! |2 - 1 2.2069706541796388e-01 6.8504065097219424e-01 -4.7003026743895970e-01 - 2 -4.0115936231307527e+00 -2.1218205387046813e+00 -9.9827955102434096e-01 - 3 2.9684129910662155e-01 3.7262517916028939e+00 -1.0816521062552547e+00 - 4 8.1382993930066636e-02 -3.5573677522989434e-02 -3.5151985944756716e+00 - 5 -6.2695071956387849e-01 -2.7259542642215560e+00 9.9501440284676745e-01 - 6 -2.9721298245652095e-01 3.9092099179600144e+00 1.7771226768578408e+00 - 7 -2.1393366306894119e+00 -2.8262788823503495e+00 2.4444601376032611e+00 - 8 1.2252752627543042e+00 1.8934056804257413e+00 -3.0563193598572838e+00 - 9 -3.4352637419435315e+00 -3.0718102718512688e+00 -2.8741859913748353e+00 - 10 3.2090680356600215e-01 -2.0401852703167229e+00 -2.4805669123527418e+00 - 11 2.3972135113483128e+00 -5.4019275833386891e+00 2.9765689120499652e+00 - 12 -4.3059430208316893e+00 -5.2598510825764047e+00 -5.2457319921326535e+00 - 13 -2.0232603864831392e-01 4.6375969951188543e+00 -1.5156362503136191e+00 - 14 -1.8428907820177531e+00 4.1515760568266957e+00 7.9422558196288362e-01 - 15 -3.3872595206479295e-01 4.9031092798381115e+00 -2.6117752561706911e+00 - 16 2.1162867716623701e+00 -4.0907630320480304e-01 4.5499311914742053e+00 - 17 4.4932801950135799e+00 3.4906677225423097e+00 -2.2635575912914447e+00 - 18 -3.5499768941512801e+00 1.1000156547358544e+00 2.2836994301124411e+00 - 19 -1.0451125955757885e+00 -2.9706240853885748e+00 -3.1507881990096265e-01 - 20 -3.3291212370733847e+00 3.2398148659892456e+00 4.6554951367993462e+00 - 21 -1.6602702919265779e+00 -5.0302444299485305e-01 -4.3331670906647055e+00 - 22 -5.1739012326876637e+00 3.7621044694833210e+00 -3.8694108983864686e+00 - 23 2.5800462945673135e+00 3.9113827058424171e+00 1.0058282701256815e+00 - 24 1.2186619874794036e+00 1.2903429720366235e+00 -2.1812056654218557e+00 - 25 5.1708533972776105e-01 -2.2724925528178241e-01 4.0361514608963143e+00 - 26 5.5528219623799939e-02 -6.3249115106540299e-01 1.1331478048837946e+00 - 27 2.3763801964792712e+00 -1.3568111553144141e-01 1.8305254882251978e+00 - 28 -7.4479731670624405e-01 6.2631724116235110e-01 7.0917585103702665e+00 - 29 -2.7946615351838360e+00 2.6497754369023019e+00 -4.9404756163540391e+00 - 30 -1.9276104520041739e+00 3.6726001318584696e+00 -1.8895215405747063e+00 - 31 2.7496645204151502e+00 1.1798091106750743e+00 1.0381378973286883e+00 - 32 2.8838885087720789e-01 -8.4153051128336498e-01 -4.5863881665538508e-01 - 33 2.4166757309749873e+00 -4.1769572659124101e+00 4.2709577151965359e+00 - 34 2.9163676292149239e+00 1.1371300137918047e-01 2.4075146002080905e-01 - 35 1.1198725269487722e+00 -4.1834197631714796e+00 2.7042173489858361e+00 - 36 -3.3387630324068235e-01 -2.8581757312520599e+00 -3.6169899983199721e-01 - 37 -4.0590700128584567e+00 1.4771680009302546e+00 -2.0374279165464233e+00 - 38 -1.3972038958445390e+00 -1.5892380209629904e+00 1.2229478783443002e+00 - 39 1.7222082871468380e+00 4.5985338951359445e-01 1.6228250135495894e+00 - 40 4.7456372038759813e+00 -2.0011059690936865e+00 -2.3332863863915216e+00 - 41 -3.0219214453293353e-01 -3.1648775808919472e+00 -3.4512151605719299e-01 - 42 -4.3738385374526683e+00 -1.4984390331917190e+00 3.4904474570057104e-01 - 43 -2.3595429224659230e-02 -5.2158149238260405e+00 1.0420171577659396e+00 - 44 3.5666455681950779e+00 -3.5061609850861370e+00 1.5276480532892043e+00 - 45 -2.2416592732685330e+00 1.2743323477451050e+00 -3.4535947332380030e+00 - 46 -2.5063043912906469e-01 -1.6306933990280013e+00 5.6310172031723624e+00 - 47 2.3589854948440898e+00 2.5421876741753944e+00 3.1695195211974569e+00 - 48 2.2574894820169225e+00 3.6956620104200244e-01 -3.5121218711855451e-01 - 49 -5.0351003329616812e+00 -3.5764874514977381e+00 -4.2176800204027698e+00 - 50 -3.5336727643305714e+00 1.0270508441019901e+00 8.7528194493804723e-01 - 51 -1.7753604141545498e+00 2.1870380688570177e+00 4.0746694362092146e+00 - 52 4.2449410599123940e+00 -4.3834286828818527e+00 3.7646766355562638e+00 - 53 2.7078936465321761e+00 3.1295683628914337e+00 1.7445195155460467e+00 - 54 8.7327387446491855e-01 7.6772540692815150e-01 -3.2402617779280607e-01 - 55 8.1016418773722532e-01 -3.1389885601606808e+00 -3.3633443469809321e+00 - 56 -1.4278855654148919e+00 4.0286484781122356e+00 -1.9992906821384984e+00 - 57 8.6542958084556795e-02 -1.1020400457566657e+00 -3.3822209055936425e-01 - 58 3.5813121257873739e+00 -5.6151617304233592e-01 1.4119734987696821e+00 - 59 3.0606661941207842e+00 1.7089133715354605e+00 -2.8032446787135936e+00 - 60 -1.3854267730385412e+00 -4.4188316872855324e+00 -2.5380111088582060e+00 - 61 -1.6904739442047063e+00 1.8488347785921950e+00 -1.3746204703475935e+00 - 62 -2.2661772905636317e+00 3.3572261480594037e+00 -2.2464258009076628e+00 - 63 5.5268470973310295e+00 -1.7435558018609616e+00 -2.0408474603750877e+00 - 64 4.5886957877184607e+00 4.8319627526991162e+00 3.9643528671273387e+00 - 65 2.2069706541796819e-01 6.8504065097220912e-01 -4.7003026743896925e-01 - 66 -4.0115936231307687e+00 -2.1218205387046734e+00 -9.9827955102434052e-01 - 67 2.9684129910660978e-01 3.7262517916029050e+00 -1.0816521062552384e+00 - 68 8.1382993930077974e-02 -3.5573677522972448e-02 -3.5151985944756765e+00 - 69 -6.2695071956388693e-01 -2.7259542642215631e+00 9.9501440284676412e-01 - 70 -2.9721298245652655e-01 3.9092099179600175e+00 1.7771226768578361e+00 - 71 -2.1393366306893342e+00 -2.8262788823503495e+00 2.4444601376032358e+00 - 72 1.2252752627542938e+00 1.8934056804257393e+00 -3.0563193598572895e+00 - 73 -3.4352637419435372e+00 -3.0718102718512790e+00 -2.8741859913748460e+00 - 74 3.2090680356598111e-01 -2.0401852703167536e+00 -2.4805669123527228e+00 - 75 2.3972135113482707e+00 -5.4019275833386740e+00 2.9765689120499244e+00 - 76 -4.3059430208317364e+00 -5.2598510825764526e+00 -5.2457319921326837e+00 - 77 -2.0232603864827342e-01 4.6375969951188312e+00 -1.5156362503135774e+00 - 78 -1.8428907820177838e+00 4.1515760568267348e+00 7.9422558196283433e-01 - 79 -3.3872595206480938e-01 4.9031092798381408e+00 -2.6117752561707013e+00 - 80 2.1162867716624736e+00 -4.0907630320472643e-01 4.5499311914741627e+00 - 81 4.4932801950136092e+00 3.4906677225423564e+00 -2.2635575912914865e+00 - 82 -3.5499768941512739e+00 1.1000156547358537e+00 2.2836994301124487e+00 - 83 -1.0451125955758018e+00 -2.9706240853885846e+00 -3.1507881990097875e-01 - 84 -3.3291212370733967e+00 3.2398148659892572e+00 4.6554951367993542e+00 - 85 -1.6602702919265730e+00 -5.0302444299485383e-01 -4.3331670906647073e+00 - 86 -5.1739012326876539e+00 3.7621044694833152e+00 -3.8694108983864619e+00 - 87 2.5800462945673321e+00 3.9113827058424304e+00 1.0058282701256924e+00 - 88 1.2186619874794191e+00 1.2903429720366129e+00 -2.1812056654218557e+00 - 89 5.1708533972772752e-01 -2.2724925528175152e-01 4.0361514608963196e+00 - 90 5.5528219623802180e-02 -6.3249115106539855e-01 1.1331478048837915e+00 - 91 2.3763801964791704e+00 -1.3568111553144696e-01 1.8305254882252111e+00 - 92 -7.4479731670623583e-01 6.2631724116234322e-01 7.0917585103702789e+00 - 93 -2.7946615351838333e+00 2.6497754369022855e+00 -4.9404756163540302e+00 - 94 -1.9276104520041852e+00 3.6726001318584620e+00 -1.8895215405747192e+00 - 95 2.7496645204152230e+00 1.1798091106750874e+00 1.0381378973287085e+00 - 96 2.8838885087721455e-01 -8.4153051128334944e-01 -4.5863881665539175e-01 - 97 2.4166757309749753e+00 -4.1769572659123906e+00 4.2709577151965137e+00 - 98 2.9163676292149106e+00 1.1371300137918533e-01 2.4075146002079389e-01 - 99 1.1198725269487790e+00 -4.1834197631714831e+00 2.7042173489858383e+00 - 100 -3.3387630324070899e-01 -2.8581757312520559e+00 -3.6169899983198323e-01 - 101 -4.0590700128584585e+00 1.4771680009302592e+00 -2.0374279165464273e+00 - 102 -1.3972038958445472e+00 -1.5892380209629957e+00 1.2229478783443182e+00 - 103 1.7222082871468471e+00 4.5985338951359389e-01 1.6228250135495899e+00 - 104 4.7456372038760062e+00 -2.0011059690936932e+00 -2.3332863863915208e+00 - 105 -3.0219214453292503e-01 -3.1648775808919218e+00 -3.4512151605718006e-01 - 106 -4.3738385374526878e+00 -1.4984390331917365e+00 3.4904474570056404e-01 - 107 -2.3595429224655809e-02 -5.2158149238260734e+00 1.0420171577659341e+00 - 108 3.5666455681952103e+00 -3.5061609850861259e+00 1.5276480532892367e+00 - 109 -2.2416592732686169e+00 1.2743323477450963e+00 -3.4535947332380101e+00 - 110 -2.5063043912905558e-01 -1.6306933990280170e+00 5.6310172031723704e+00 - 111 2.3589854948441089e+00 2.5421876741754099e+00 3.1695195211974729e+00 - 112 2.2574894820168732e+00 3.6956620104201315e-01 -3.5121218711858404e-01 - 113 -5.0351003329616457e+00 -3.5764874514977296e+00 -4.2176800204027822e+00 - 114 -3.5336727643305612e+00 1.0270508441019932e+00 8.7528194493802980e-01 - 115 -1.7753604141545398e+00 2.1870380688570323e+00 4.0746694362092191e+00 - 116 4.2449410599123807e+00 -4.3834286828818456e+00 3.7646766355562535e+00 - 117 2.7078936465321530e+00 3.1295683628914439e+00 1.7445195155460547e+00 - 118 8.7327387446490479e-01 7.6772540692814195e-01 -3.2402617779281701e-01 - 119 8.1016418773726873e-01 -3.1389885601607035e+00 -3.3633443469809379e+00 - 120 -1.4278855654148834e+00 4.0286484781122365e+00 -1.9992906821384921e+00 - 121 8.6542958084561361e-02 -1.1020400457566630e+00 -3.3822209055936658e-01 - 122 3.5813121257873619e+00 -5.6151617304233381e-01 1.4119734987696921e+00 - 123 3.0606661941208451e+00 1.7089133715354738e+00 -2.8032446787136314e+00 - 124 -1.3854267730385910e+00 -4.4188316872855555e+00 -2.5380111088582140e+00 - 125 -1.6904739442046883e+00 1.8488347785921939e+00 -1.3746204703476019e+00 - 126 -2.2661772905636428e+00 3.3572261480594063e+00 -2.2464258009076707e+00 - 127 5.5268470973310269e+00 -1.7435558018609683e+00 -2.0408474603750935e+00 - 128 4.5886957877184660e+00 4.8319627526991473e+00 3.9643528671273507e+00 - 129 2.2069706541797016e-01 6.8504065097220879e-01 -4.7003026743897031e-01 - 130 -4.0115936231307545e+00 -2.1218205387046774e+00 -9.9827955102434029e-01 - 131 2.9684129910662832e-01 3.7262517916029032e+00 -1.0816521062552653e+00 - 132 8.1382993930064915e-02 -3.5573677522977583e-02 -3.5151985944756676e+00 - 133 -6.2695071956387305e-01 -2.7259542642215586e+00 9.9501440284676268e-01 - 134 -2.9721298245652084e-01 3.9092099179600148e+00 1.7771226768578388e+00 - 135 -2.1393366306894110e+00 -2.8262788823503509e+00 2.4444601376032611e+00 - 136 1.2252752627543320e+00 1.8934056804256958e+00 -3.0563193598572895e+00 - 137 -3.4352637419435204e+00 -3.0718102718512599e+00 -2.8741859913748296e+00 - 138 3.2090680356600421e-01 -2.0401852703166861e+00 -2.4805669123527521e+00 - 139 2.3972135113483071e+00 -5.4019275833386908e+00 2.9765689120499732e+00 - 140 -4.3059430208317151e+00 -5.2598510825764251e+00 -5.2457319921326651e+00 - 141 -2.0232603864833151e-01 4.6375969951188551e+00 -1.5156362503136349e+00 - 142 -1.8428907820177429e+00 4.1515760568266726e+00 7.9422558196288195e-01 - 143 -3.3872595206479300e-01 4.9031092798381231e+00 -2.6117752561706946e+00 - 144 2.1162867716623657e+00 -4.0907630320476768e-01 4.5499311914742577e+00 - 145 4.4932801950135950e+00 3.4906677225423155e+00 -2.2635575912914421e+00 - 146 -3.5499768941512975e+00 1.1000156547358841e+00 2.2836994301124527e+00 - 147 -1.0451125955757994e+00 -2.9706240853885535e+00 -3.1507881990094722e-01 - 148 -3.3291212370734145e+00 3.2398148659892740e+00 4.6554951367993631e+00 - 149 -1.6602702919265679e+00 -5.0302444299487636e-01 -4.3331670906647126e+00 - 150 -5.1739012326876566e+00 3.7621044694833303e+00 -3.8694108983864757e+00 - 151 2.5800462945673113e+00 3.9113827058424002e+00 1.0058282701256753e+00 - 152 1.2186619874794138e+00 1.2903429720366129e+00 -2.1812056654218486e+00 - 153 5.1708533972770687e-01 -2.2724925528171916e-01 4.0361514608963169e+00 - 154 5.5528219623780462e-02 -6.3249115106538389e-01 1.1331478048837897e+00 - 155 2.3763801964792948e+00 -1.3568111553147827e-01 1.8305254882251900e+00 - 156 -7.4479731670623550e-01 6.2631724116235243e-01 7.0917585103702718e+00 - 157 -2.7946615351838284e+00 2.6497754369022903e+00 -4.9404756163540497e+00 - 158 -1.9276104520041843e+00 3.6726001318584816e+00 -1.8895215405747190e+00 - 159 2.7496645204151537e+00 1.1798091106750430e+00 1.0381378973286741e+00 - 160 2.8838885087720562e-01 -8.4153051128334488e-01 -4.5863881665538292e-01 - 161 2.4166757309749971e+00 -4.1769572659124279e+00 4.2709577151965528e+00 - 162 2.9163676292149221e+00 1.1371300137917556e-01 2.4075146002081926e-01 - 163 1.1198725269487704e+00 -4.1834197631714725e+00 2.7042173489858419e+00 - 164 -3.3387630324067230e-01 -2.8581757312520399e+00 -3.6169899983198373e-01 - 165 -4.0590700128584549e+00 1.4771680009302548e+00 -2.0374279165464242e+00 - 166 -1.3972038958445503e+00 -1.5892380209629917e+00 1.2229478783443049e+00 - 167 1.7222082871468414e+00 4.5985338951358495e-01 1.6228250135495910e+00 - 168 4.7456372038760000e+00 -2.0011059690937412e+00 -2.3332863863915572e+00 - 169 -3.0219214453292764e-01 -3.1648775808919631e+00 -3.4512151605719948e-01 - 170 -4.3738385374526203e+00 -1.4984390331916571e+00 3.4904474570061345e-01 - 171 -2.3595429224668379e-02 -5.2158149238260263e+00 1.0420171577659338e+00 - 172 3.5666455681950744e+00 -3.5061609850861055e+00 1.5276480532891945e+00 - 173 -2.2416592732685294e+00 1.2743323477451018e+00 -3.4535947332379942e+00 - 174 -2.5063043912912020e-01 -1.6306933990281038e+00 5.6310172031723082e+00 - 175 2.3589854948440974e+00 2.5421876741754068e+00 3.1695195211974556e+00 - 176 2.2574894820169185e+00 3.6956620104199356e-01 -3.5121218711856128e-01 - 177 -5.0351003329616919e+00 -3.5764874514977327e+00 -4.2176800204027627e+00 - 178 -3.5336727643305541e+00 1.0270508441020134e+00 8.7528194493807898e-01 - 179 -1.7753604141545791e+00 2.1870380688570679e+00 4.0746694362092475e+00 - 180 4.2449410599123940e+00 -4.3834286828818456e+00 3.7646766355562638e+00 - 181 2.7078936465321841e+00 3.1295683628914128e+00 1.7445195155460405e+00 - 182 8.7327387446490778e-01 7.6772540692813296e-01 -3.2402617779282272e-01 - 183 8.1016418773725840e-01 -3.1389885601608025e+00 -3.3633443469809117e+00 - 184 -1.4278855654148874e+00 4.0286484781122418e+00 -1.9992906821384864e+00 - 185 8.6542958084555810e-02 -1.1020400457566488e+00 -3.3822209055936331e-01 - 186 3.5813121257873899e+00 -5.6151617304226631e-01 1.4119734987696575e+00 - 187 3.0606661941208060e+00 1.7089133715354359e+00 -2.8032446787136203e+00 - 188 -1.3854267730385068e+00 -4.4188316872855200e+00 -2.5380111088581576e+00 - 189 -1.6904739442047096e+00 1.8488347785921984e+00 -1.3746204703476179e+00 - 190 -2.2661772905636401e+00 3.3572261480593943e+00 -2.2464258009076730e+00 - 191 5.5268470973310437e+00 -1.7435558018609418e+00 -2.0408474603750744e+00 - 192 4.5886957877184242e+00 4.8319627526991029e+00 3.9643528671273085e+00 - 193 2.2069706541797257e-01 6.8504065097221956e-01 -4.7003026743897658e-01 - 194 -4.0115936231307678e+00 -2.1218205387046702e+00 -9.9827955102433918e-01 - 195 2.9684129910662271e-01 3.7262517916029125e+00 -1.0816521062552538e+00 - 196 8.1382993930076294e-02 -3.5573677522958265e-02 -3.5151985944756707e+00 - 197 -6.2695071956388182e-01 -2.7259542642215626e+00 9.9501440284675990e-01 - 198 -2.9721298245652805e-01 3.9092099179600188e+00 1.7771226768578356e+00 - 199 -2.1393366306893302e+00 -2.8262788823503477e+00 2.4444601376032313e+00 - 200 1.2252752627543146e+00 1.8934056804256987e+00 -3.0563193598573068e+00 - 201 -3.4352637419435266e+00 -3.0718102718512736e+00 -2.8741859913748398e+00 - 202 3.2090680356599371e-01 -2.0401852703167211e+00 -2.4805669123527156e+00 - 203 2.3972135113482680e+00 -5.4019275833386802e+00 2.9765689120499337e+00 - 204 -4.3059430208317613e+00 -5.2598510825764695e+00 -5.2457319921326944e+00 - 205 -2.0232603864829354e-01 4.6375969951188338e+00 -1.5156362503135945e+00 - 206 -1.8428907820177813e+00 4.1515760568267162e+00 7.9422558196281756e-01 - 207 -3.3872595206481426e-01 4.9031092798381586e+00 -2.6117752561707119e+00 - 208 2.1162867716624718e+00 -4.0907630320468791e-01 4.5499311914742151e+00 - 209 4.4932801950136279e+00 3.4906677225423635e+00 -2.2635575912914878e+00 - 210 -3.5499768941512886e+00 1.1000156547358813e+00 2.2836994301124611e+00 - 211 -1.0451125955758147e+00 -2.9706240853885610e+00 -3.1507881990096293e-01 - 212 -3.3291212370734238e+00 3.2398148659892878e+00 4.6554951367993693e+00 - 213 -1.6602702919265648e+00 -5.0302444299487847e-01 -4.3331670906647108e+00 - 214 -5.1739012326876468e+00 3.7621044694833254e+00 -3.8694108983864703e+00 - 215 2.5800462945673317e+00 3.9113827058424122e+00 1.0058282701256864e+00 - 216 1.2186619874794311e+00 1.2903429720366013e+00 -2.1812056654218535e+00 - 217 5.1708533972766846e-01 -2.2724925528168946e-01 4.0361514608963196e+00 - 218 5.5528219623788490e-02 -6.3249115106538056e-01 1.1331478048837924e+00 - 219 2.3763801964791940e+00 -1.3568111553149587e-01 1.8305254882252089e+00 - 220 -7.4479731670622606e-01 6.2631724116234322e-01 7.0917585103702887e+00 - 221 -2.7946615351838302e+00 2.6497754369022801e+00 -4.9404756163540391e+00 - 222 -1.9276104520042008e+00 3.6726001318584740e+00 -1.8895215405747330e+00 - 223 2.7496645204152319e+00 1.1798091106750590e+00 1.0381378973286974e+00 - 224 2.8838885087721700e-01 -8.4153051128332768e-01 -4.5863881665539608e-01 - 225 2.4166757309749807e+00 -4.1769572659124004e+00 4.2709577151965235e+00 - 226 2.9163676292149070e+00 1.1371300137917927e-01 2.4075146002080447e-01 - 227 1.1198725269487768e+00 -4.1834197631714760e+00 2.7042173489858441e+00 - 228 -3.3387630324070566e-01 -2.8581757312520439e+00 -3.6169899983197878e-01 - 229 -4.0590700128584567e+00 1.4771680009302595e+00 -2.0374279165464277e+00 - 230 -1.3972038958445552e+00 -1.5892380209629935e+00 1.2229478783443208e+00 - 231 1.7222082871468489e+00 4.5985338951358373e-01 1.6228250135495903e+00 - 232 4.7456372038760311e+00 -2.0011059690937398e+00 -2.3332863863915465e+00 - 233 -3.0219214453292259e-01 -3.1648775808919369e+00 -3.4512151605718677e-01 - 234 -4.3738385374526416e+00 -1.4984390331916755e+00 3.4904474570060623e-01 - 235 -2.3595429224662654e-02 -5.2158149238260574e+00 1.0420171577659318e+00 - 236 3.5666455681952125e+00 -3.5061609850860989e+00 1.5276480532892287e+00 - 237 -2.2416592732686125e+00 1.2743323477450939e+00 -3.4535947332380013e+00 - 238 -2.5063043912911293e-01 -1.6306933990281149e+00 5.6310172031723180e+00 - 239 2.3589854948441142e+00 2.5421876741754192e+00 3.1695195211974720e+00 - 240 2.2574894820168705e+00 3.6956620104200660e-01 -3.5121218711858965e-01 - 241 -5.0351003329616537e+00 -3.5764874514977270e+00 -4.2176800204027769e+00 - 242 -3.5336727643305532e+00 1.0270508441020201e+00 8.7528194493806333e-01 - 243 -1.7753604141545702e+00 2.1870380688570807e+00 4.0746694362092573e+00 - 244 4.2449410599123789e+00 -4.3834286828818376e+00 3.7646766355562513e+00 - 245 2.7078936465321632e+00 3.1295683628914222e+00 1.7445195155460478e+00 - 246 8.7327387446489713e-01 7.6772540692812541e-01 -3.2402617779283199e-01 - 247 8.1016418773729493e-01 -3.1389885601608345e+00 -3.3633443469809090e+00 - 248 -1.4278855654148732e+00 4.0286484781122391e+00 -1.9992906821384748e+00 - 249 8.6542958084561653e-02 -1.1020400457566464e+00 -3.3822209055936525e-01 - 250 3.5813121257873770e+00 -5.6151617304225387e-01 1.4119734987696599e+00 - 251 3.0606661941208659e+00 1.7089133715354510e+00 -2.8032446787136567e+00 - 252 -1.3854267730385641e+00 -4.4188316872855458e+00 -2.5380111088581714e+00 - 253 -1.6904739442046899e+00 1.8488347785921966e+00 -1.3746204703476279e+00 - 254 -2.2661772905636504e+00 3.3572261480593952e+00 -2.2464258009076814e+00 - 255 5.5268470973310402e+00 -1.7435558018609474e+00 -2.0408474603750806e+00 - 256 4.5886957877184305e+00 4.8319627526991367e+00 3.9643528671273285e+00 - 257 2.2069706541795950e-01 6.8504065097218869e-01 -4.7003026743895610e-01 - 258 -4.0115936231307510e+00 -2.1218205387046849e+00 -9.9827955102435095e-01 - 259 2.9684129910662382e-01 3.7262517916029005e+00 -1.0816521062552633e+00 - 260 8.1382993930067704e-02 -3.5573677522989407e-02 -3.5151985944756468e+00 - 261 -6.2695071956386683e-01 -2.7259542642215449e+00 9.9501440284675535e-01 - 262 -2.9721298245652056e-01 3.9092099179600162e+00 1.7771226768578341e+00 - 263 -2.1393366306894177e+00 -2.8262788823503620e+00 2.4444601376032922e+00 - 264 1.2252752627542955e+00 1.8934056804257171e+00 -3.0563193598572829e+00 - 265 -3.4352637419435412e+00 -3.0718102718512759e+00 -2.8741859913748469e+00 - 266 3.2090680356599988e-01 -2.0401852703167251e+00 -2.4805669123527676e+00 - 267 2.3972135113482911e+00 -5.4019275833386953e+00 2.9765689120499421e+00 - 268 -4.3059430208316689e+00 -5.2598510825763967e+00 -5.2457319921326473e+00 - 269 -2.0232603864830292e-01 4.6375969951188649e+00 -1.5156362503135969e+00 - 270 -1.8428907820177696e+00 4.1515760568267233e+00 7.9422558196288684e-01 - 271 -3.3872595206475870e-01 4.9031092798380849e+00 -2.6117752561706160e+00 - 272 2.1162867716623714e+00 -4.0907630320482452e-01 4.5499311914741813e+00 - 273 4.4932801950135710e+00 3.4906677225423062e+00 -2.2635575912914434e+00 - 274 -3.5499768941512722e+00 1.1000156547358613e+00 2.2836994301124474e+00 - 275 -1.0451125955757994e+00 -2.9706240853885806e+00 -3.1507881990096065e-01 - 276 -3.3291212370733985e+00 3.2398148659892505e+00 4.6554951367993604e+00 - 277 -1.6602702919265782e+00 -5.0302444299485227e-01 -4.3331670906647064e+00 - 278 -5.1739012326877027e+00 3.7621044694833312e+00 -3.8694108983864908e+00 - 279 2.5800462945673277e+00 3.9113827058424118e+00 1.0058282701257071e+00 - 280 1.2186619874794087e+00 1.2903429720366195e+00 -2.1812056654218517e+00 - 281 5.1708533972776816e-01 -2.2724925528178760e-01 4.0361514608963054e+00 - 282 5.5528219623796962e-02 -6.3249115106540654e-01 1.1331478048837642e+00 - 283 2.3763801964792592e+00 -1.3568111553142109e-01 1.8305254882251945e+00 - 284 -7.4479731670625093e-01 6.2631724116234289e-01 7.0917585103703207e+00 - 285 -2.7946615351838298e+00 2.6497754369023023e+00 -4.9404756163540196e+00 - 286 -1.9276104520041655e+00 3.6726001318584709e+00 -1.8895215405746977e+00 - 287 2.7496645204151489e+00 1.1798091106750759e+00 1.0381378973286892e+00 - 288 2.8838885087721156e-01 -8.4153051128335987e-01 -4.5863881665538175e-01 - 289 2.4166757309749642e+00 -4.1769572659123702e+00 4.2709577151964977e+00 - 290 2.9163676292149106e+00 1.1371300137917861e-01 2.4075146002081471e-01 - 291 1.1198725269487630e+00 -4.1834197631714796e+00 2.7042173489858201e+00 - 292 -3.3387630324067030e-01 -2.8581757312520510e+00 -3.6169899983200149e-01 - 293 -4.0590700128584514e+00 1.4771680009302361e+00 -2.0374279165464073e+00 - 294 -1.3972038958445367e+00 -1.5892380209629922e+00 1.2229478783443035e+00 - 295 1.7222082871468409e+00 4.5985338951359545e-01 1.6228250135495998e+00 - 296 4.7456372038759742e+00 -2.0011059690936954e+00 -2.3332863863915265e+00 - 297 -3.0219214453293974e-01 -3.1648775808919387e+00 -3.4512151605719826e-01 - 298 -4.3738385374526549e+00 -1.4984390331917208e+00 3.4904474570055544e-01 - 299 -2.3595429224524022e-02 -5.2158149238260458e+00 1.0420171577660298e+00 - 300 3.5666455681951028e+00 -3.5061609850861579e+00 1.5276480532892593e+00 - 301 -2.2416592732685787e+00 1.2743323477451685e+00 -3.4535947332380652e+00 - 302 -2.5063043912908722e-01 -1.6306933990280201e+00 5.6310172031723980e+00 - 303 2.3589854948440219e+00 2.5421876741753469e+00 3.1695195211973655e+00 - 304 2.2574894820168985e+00 3.6956620104200411e-01 -3.5121218711853169e-01 - 305 -5.0351003329616608e+00 -3.5764874514977105e+00 -4.2176800204027334e+00 - 306 -3.5336727643305612e+00 1.0270508441019646e+00 8.7528194493803491e-01 - 307 -1.7753604141545543e+00 2.1870380688570088e+00 4.0746694362092146e+00 - 308 4.2449410599124109e+00 -4.3834286828818856e+00 3.7646766355563068e+00 - 309 2.7078936465321526e+00 3.1295683628914150e+00 1.7445195155460047e+00 - 310 8.7327387446492655e-01 7.6772540692816349e-01 -3.2402617779278775e-01 - 311 8.1016418773722509e-01 -3.1389885601606804e+00 -3.3633443469808970e+00 - 312 -1.4278855654148712e+00 4.0286484781122223e+00 -1.9992906821384726e+00 - 313 8.6542958084541710e-02 -1.1020400457566728e+00 -3.3822209055940211e-01 - 314 3.5813121257873544e+00 -5.6151617304232226e-01 1.4119734987696428e+00 - 315 3.0606661941207829e+00 1.7089133715354525e+00 -2.8032446787137033e+00 - 316 -1.3854267730385401e+00 -4.4188316872855236e+00 -2.5380111088582056e+00 - 317 -1.6904739442046786e+00 1.8488347785921777e+00 -1.3746204703475302e+00 - 318 -2.2661772905635900e+00 3.3572261480593659e+00 -2.2464258009076215e+00 - 319 5.5268470973310126e+00 -1.7435558018608883e+00 -2.0408474603750251e+00 - 320 4.5886957877184447e+00 4.8319627526991313e+00 3.9643528671273356e+00 - 321 2.2069706541796461e-01 6.8504065097220423e-01 -4.7003026743896670e-01 - 322 -4.0115936231307687e+00 -2.1218205387046756e+00 -9.9827955102434740e-01 - 323 2.9684129910661305e-01 3.7262517916029116e+00 -1.0816521062552500e+00 - 324 8.1382993930087022e-02 -3.5573677522965488e-02 -3.5151985944756472e+00 - 325 -6.2695071956387505e-01 -2.7259542642215546e+00 9.9501440284675335e-01 - 326 -2.9721298245652472e-01 3.9092099179600184e+00 1.7771226768578299e+00 - 327 -2.1393366306893453e+00 -2.8262788823503602e+00 2.4444601376032646e+00 - 328 1.2252752627542776e+00 1.8934056804257120e+00 -3.0563193598572980e+00 - 329 -3.4352637419435452e+00 -3.0718102718512852e+00 -2.8741859913748549e+00 - 330 3.2090680356598333e-01 -2.0401852703167540e+00 -2.4805669123527450e+00 - 331 2.3972135113482511e+00 -5.4019275833386802e+00 2.9765689120499013e+00 - 332 -4.3059430208317107e+00 -5.2598510825764366e+00 -5.2457319921326730e+00 - 333 -2.0232603864826401e-01 4.6375969951188374e+00 -1.5156362503135590e+00 - 334 -1.8428907820178062e+00 4.1515760568267597e+00 7.9422558196284432e-01 - 335 -3.3872595206477341e-01 4.9031092798381133e+00 -2.6117752561706280e+00 - 336 2.1162867716624745e+00 -4.0907630320475385e-01 4.5499311914741325e+00 - 337 4.4932801950136048e+00 3.4906677225423564e+00 -2.2635575912914869e+00 - 338 -3.5499768941512673e+00 1.1000156547358557e+00 2.2836994301124514e+00 - 339 -1.0451125955758145e+00 -2.9706240853885810e+00 -3.1507881990097597e-01 - 340 -3.3291212370734091e+00 3.2398148659892634e+00 4.6554951367993676e+00 - 341 -1.6602702919265708e+00 -5.0302444299485727e-01 -4.3331670906647055e+00 - 342 -5.1739012326876948e+00 3.7621044694833405e+00 -3.8694108983864934e+00 - 343 2.5800462945673437e+00 3.9113827058424198e+00 1.0058282701257135e+00 - 344 1.2186619874794211e+00 1.2903429720366129e+00 -2.1812056654218535e+00 - 345 5.1708533972772974e-01 -2.2724925528175427e-01 4.0361514608963116e+00 - 346 5.5528219623807308e-02 -6.3249115106540355e-01 1.1331478048837684e+00 - 347 2.3763801964791611e+00 -1.3568111553142059e-01 1.8305254882252080e+00 - 348 -7.4479731670624560e-01 6.2631724116233867e-01 7.0917585103703304e+00 - 349 -2.7946615351838258e+00 2.6497754369022872e+00 -4.9404756163540107e+00 - 350 -1.9276104520041804e+00 3.6726001318584616e+00 -1.8895215405747143e+00 - 351 2.7496645204152212e+00 1.1798091106750888e+00 1.0381378973287108e+00 - 352 2.8838885087721855e-01 -8.4153051128334244e-01 -4.5863881665538886e-01 - 353 2.4166757309749531e+00 -4.1769572659123497e+00 4.2709577151964746e+00 - 354 2.9163676292148990e+00 1.1371300137918280e-01 2.4075146002080219e-01 - 355 1.1198725269487693e+00 -4.1834197631714796e+00 2.7042173489858197e+00 - 356 -3.3387630324069922e-01 -2.8581757312520502e+00 -3.6169899983199522e-01 - 357 -4.0590700128584558e+00 1.4771680009302395e+00 -2.0374279165464109e+00 - 358 -1.3972038958445405e+00 -1.5892380209629930e+00 1.2229478783443177e+00 - 359 1.7222082871468514e+00 4.5985338951359567e-01 1.6228250135495981e+00 - 360 4.7456372038760009e+00 -2.0011059690936985e+00 -2.3332863863915203e+00 - 361 -3.0219214453292959e-01 -3.1648775808919178e+00 -3.4512151605718333e-01 - 362 -4.3738385374526789e+00 -1.4984390331917412e+00 3.4904474570054739e-01 - 363 -2.3595429224526020e-02 -5.2158149238260805e+00 1.0420171577660184e+00 - 364 3.5666455681952325e+00 -3.5061609850861495e+00 1.5276480532892898e+00 - 365 -2.2416592732686591e+00 1.2743323477451618e+00 -3.4535947332380719e+00 - 366 -2.5063043912908695e-01 -1.6306933990280372e+00 5.6310172031724122e+00 - 367 2.3589854948440454e+00 2.5421876741753655e+00 3.1695195211973877e+00 - 368 2.2574894820168550e+00 3.6956620104201510e-01 -3.5121218711855912e-01 - 369 -5.0351003329616244e+00 -3.5764874514977043e+00 -4.2176800204027485e+00 - 370 -3.5336727643305563e+00 1.0270508441019661e+00 8.7528194493800981e-01 - 371 -1.7753604141545436e+00 2.1870380688570190e+00 4.0746694362092262e+00 - 372 4.2449410599124038e+00 -4.3834286828818847e+00 3.7646766355563064e+00 - 373 2.7078936465321273e+00 3.1295683628914359e+00 1.7445195155460174e+00 - 374 8.7327387446491589e-01 7.6772540692815416e-01 -3.2402617779279774e-01 - 375 8.1016418773725907e-01 -3.1389885601607097e+00 -3.3633443469808988e+00 - 376 -1.4278855654148637e+00 4.0286484781122240e+00 -1.9992906821384671e+00 - 377 8.6542958084548427e-02 -1.1020400457566699e+00 -3.3822209055940633e-01 - 378 3.5813121257873468e+00 -5.6151617304231294e-01 1.4119734987696477e+00 - 379 3.0606661941208517e+00 1.7089133715354750e+00 -2.8032446787137393e+00 - 380 -1.3854267730385890e+00 -4.4188316872855422e+00 -2.5380111088582140e+00 - 381 -1.6904739442046597e+00 1.8488347785921742e+00 -1.3746204703475413e+00 - 382 -2.2661772905636015e+00 3.3572261480593704e+00 -2.2464258009076317e+00 - 383 5.5268470973310064e+00 -1.7435558018608961e+00 -2.0408474603750344e+00 - 384 4.5886957877184473e+00 4.8319627526991615e+00 3.9643528671273440e+00 - 385 2.2069706541796574e-01 6.8504065097220357e-01 -4.7003026743896748e-01 - 386 -4.0115936231307554e+00 -2.1218205387046800e+00 -9.9827955102434718e-01 - 387 2.9684129910663370e-01 3.7262517916029134e+00 -1.0816521062552793e+00 - 388 8.1382993930071632e-02 -3.5573677522972282e-02 -3.5151985944756428e+00 - 389 -6.2695071956386306e-01 -2.7259542642215520e+00 9.9501440284675191e-01 - 390 -2.9721298245652045e-01 3.9092099179600188e+00 1.7771226768578334e+00 - 391 -2.1393366306894133e+00 -2.8262788823503597e+00 2.4444601376032886e+00 - 392 1.2252752627543220e+00 1.8934056804256691e+00 -3.0563193598572966e+00 - 393 -3.4352637419435381e+00 -3.0718102718512745e+00 -2.8741859913748469e+00 - 394 3.2090680356599965e-01 -2.0401852703166901e+00 -2.4805669123527738e+00 - 395 2.3972135113482924e+00 -5.4019275833387059e+00 2.9765689120499550e+00 - 396 -4.3059430208317000e+00 -5.2598510825764180e+00 -5.2457319921326606e+00 - 397 -2.0232603864831816e-01 4.6375969951188791e+00 -1.5156362503136123e+00 - 398 -1.8428907820177574e+00 4.1515760568267002e+00 7.9422558196289239e-01 - 399 -3.3872595206475659e-01 4.9031092798380964e+00 -2.6117752561706191e+00 - 400 2.1162867716623746e+00 -4.0907630320478661e-01 4.5499311914742329e+00 - 401 4.4932801950135861e+00 3.4906677225423146e+00 -2.2635575912914474e+00 - 402 -3.5499768941512930e+00 1.1000156547358921e+00 2.2836994301124585e+00 - 403 -1.0451125955758152e+00 -2.9706240853885579e+00 -3.1507881990094821e-01 - 404 -3.3291212370734269e+00 3.2398148659892798e+00 4.6554951367993782e+00 - 405 -1.6602702919265688e+00 -5.0302444299487736e-01 -4.3331670906647126e+00 - 406 -5.1739012326876903e+00 3.7621044694833454e+00 -3.8694108983865001e+00 - 407 2.5800462945673281e+00 3.9113827058423949e+00 1.0058282701257060e+00 - 408 1.2186619874794165e+00 1.2903429720366129e+00 -2.1812056654218455e+00 - 409 5.1708533972771120e-01 -2.2724925528172302e-01 4.0361514608963116e+00 - 410 5.5528219623785194e-02 -6.3249115106539078e-01 1.1331478048837604e+00 - 411 2.3763801964792828e+00 -1.3568111553145581e-01 1.8305254882251898e+00 - 412 -7.4479731670624660e-01 6.2631724116234833e-01 7.0917585103703242e+00 - 413 -2.7946615351838231e+00 2.6497754369022926e+00 -4.9404756163540275e+00 - 414 -1.9276104520041766e+00 3.6726001318584816e+00 -1.8895215405747110e+00 - 415 2.7496645204151515e+00 1.1798091106750437e+00 1.0381378973286739e+00 - 416 2.8838885087720939e-01 -8.4153051128334011e-01 -4.5863881665538303e-01 - 417 2.4166757309749674e+00 -4.1769572659123835e+00 4.2709577151965066e+00 - 418 2.9163676292149079e+00 1.1371300137917027e-01 2.4075146002082637e-01 - 419 1.1198725269487606e+00 -4.1834197631714751e+00 2.7042173489858241e+00 - 420 -3.3387630324066614e-01 -2.8581757312520404e+00 -3.6169899983199694e-01 - 421 -4.0590700128584505e+00 1.4771680009302361e+00 -2.0374279165464078e+00 - 422 -1.3972038958445459e+00 -1.5892380209629926e+00 1.2229478783443071e+00 - 423 1.7222082871468458e+00 4.5985338951358662e-01 1.6228250135496034e+00 - 424 4.7456372038760000e+00 -2.0011059690937394e+00 -2.3332863863915549e+00 - 425 -3.0219214453293625e-01 -3.1648775808919538e+00 -3.4512151605720665e-01 - 426 -4.3738385374526114e+00 -1.4984390331916562e+00 3.4904474570060040e-01 - 427 -2.3595429224533726e-02 -5.2158149238260352e+00 1.0420171577660287e+00 - 428 3.5666455681950890e+00 -3.5061609850861308e+00 1.5276480532892425e+00 - 429 -2.2416592732685685e+00 1.2743323477451673e+00 -3.4535947332380612e+00 - 430 -2.5063043912915178e-01 -1.6306933990281269e+00 5.6310172031723464e+00 - 431 2.3589854948440290e+00 2.5421876741753557e+00 3.1695195211973681e+00 - 432 2.2574894820169003e+00 3.6956620104200233e-01 -3.5121218711853208e-01 - 433 -5.0351003329616697e+00 -3.5764874514977065e+00 -4.2176800204027272e+00 - 434 -3.5336727643305452e+00 1.0270508441019932e+00 8.7528194493806688e-01 - 435 -1.7753604141545827e+00 2.1870380688570616e+00 4.0746694362092484e+00 - 436 4.2449410599124047e+00 -4.3834286828818838e+00 3.7646766355563019e+00 - 437 2.7078936465321637e+00 3.1295683628913982e+00 1.7445195155460003e+00 - 438 8.7327387446491422e-01 7.6772540692814106e-01 -3.2402617779280735e-01 - 439 8.1016418773725163e-01 -3.1389885601608056e+00 -3.3633443469808784e+00 - 440 -1.4278855654148579e+00 4.0286484781122276e+00 -1.9992906821384531e+00 - 441 8.6542958084542529e-02 -1.1020400457566568e+00 -3.3822209055939995e-01 - 442 3.5813121257873655e+00 -5.6151617304224299e-01 1.4119734987696129e+00 - 443 3.0606661941208109e+00 1.7089133715354334e+00 -2.8032446787137379e+00 - 444 -1.3854267730385008e+00 -4.4188316872855031e+00 -2.5380111088581505e+00 - 445 -1.6904739442046797e+00 1.8488347785921757e+00 -1.3746204703475602e+00 - 446 -2.2661772905636011e+00 3.3572261480593544e+00 -2.2464258009076348e+00 - 447 5.5268470973310260e+00 -1.7435558018608623e+00 -2.0408474603750131e+00 - 448 4.5886957877184003e+00 4.8319627526991118e+00 3.9643528671272996e+00 - 449 2.2069706541796852e-01 6.8504065097221456e-01 -4.7003026743897436e-01 - 450 -4.0115936231307696e+00 -2.1218205387046729e+00 -9.9827955102434629e-01 - 451 2.9684129910662371e-01 3.7262517916029192e+00 -1.0816521062552638e+00 - 452 8.1382993930086509e-02 -3.5573677522951652e-02 -3.5151985944756450e+00 - 453 -6.2695071956387238e-01 -2.7259542642215568e+00 9.9501440284675036e-01 - 454 -2.9721298245652444e-01 3.9092099179600224e+00 1.7771226768578305e+00 - 455 -2.1393366306893413e+00 -2.8262788823503588e+00 2.4444601376032624e+00 - 456 1.2252752627543024e+00 1.8934056804256718e+00 -3.0563193598573175e+00 - 457 -3.4352637419435341e+00 -3.0718102718512781e+00 -2.8741859913748464e+00 - 458 3.2090680356598733e-01 -2.0401852703167274e+00 -2.4805669123527503e+00 - 459 2.3972135113482471e+00 -5.4019275833386891e+00 2.9765689120499119e+00 - 460 -4.3059430208317444e+00 -5.2598510825764615e+00 -5.2457319921326926e+00 - 461 -2.0232603864828436e-01 4.6375969951188374e+00 -1.5156362503135770e+00 - 462 -1.8428907820177900e+00 4.1515760568267490e+00 7.9422558196283399e-01 - 463 -3.3872595206477474e-01 4.9031092798381248e+00 -2.6117752561706324e+00 - 464 2.1162867716624758e+00 -4.0907630320470723e-01 4.5499311914741929e+00 - 465 4.4932801950136181e+00 3.4906677225423626e+00 -2.2635575912914887e+00 - 466 -3.5499768941512819e+00 1.1000156547358853e+00 2.2836994301124642e+00 - 467 -1.0451125955758329e+00 -2.9706240853885633e+00 -3.1507881990096492e-01 - 468 -3.3291212370734353e+00 3.2398148659892936e+00 4.6554951367993826e+00 - 469 -1.6602702919265626e+00 -5.0302444299488103e-01 -4.3331670906647117e+00 - 470 -5.1739012326876859e+00 3.7621044694833503e+00 -3.8694108983865023e+00 - 471 2.5800462945673459e+00 3.9113827058424060e+00 1.0058282701257162e+00 - 472 1.2186619874794307e+00 1.2903429720366022e+00 -2.1812056654218517e+00 - 473 5.1708533972767157e-01 -2.2724925528168982e-01 4.0361514608963143e+00 - 474 5.5528219623792355e-02 -6.3249115106538600e-01 1.1331478048837658e+00 - 475 2.3763801964791811e+00 -1.3568111553147227e-01 1.8305254882252029e+00 - 476 -7.4479731670624161e-01 6.2631724116234400e-01 7.0917585103703358e+00 - 477 -2.7946615351838213e+00 2.6497754369022792e+00 -4.9404756163540204e+00 - 478 -1.9276104520041930e+00 3.6726001318584767e+00 -1.8895215405747254e+00 - 479 2.7496645204152288e+00 1.1798091106750601e+00 1.0381378973286983e+00 - 480 2.8838885087722121e-01 -8.4153051128332101e-01 -4.5863881665539363e-01 - 481 2.4166757309749540e+00 -4.1769572659123604e+00 4.2709577151964826e+00 - 482 2.9163676292148981e+00 1.1371300137917660e-01 2.4075146002081080e-01 - 483 1.1198725269487668e+00 -4.1834197631714760e+00 2.7042173489858259e+00 - 484 -3.3387630324069478e-01 -2.8581757312520364e+00 -3.6169899983198450e-01 - 485 -4.0590700128584523e+00 1.4771680009302415e+00 -2.0374279165464131e+00 - 486 -1.3972038958445470e+00 -1.5892380209629930e+00 1.2229478783443222e+00 - 487 1.7222082871468545e+00 4.5985338951358645e-01 1.6228250135496032e+00 - 488 4.7456372038760231e+00 -2.0011059690937474e+00 -2.3332863863915501e+00 - 489 -3.0219214453292886e-01 -3.1648775808919329e+00 -3.4512151605719138e-01 - 490 -4.3738385374526327e+00 -1.4984390331916750e+00 3.4904474570059174e-01 - 491 -2.3595429224533331e-02 -5.2158149238260680e+00 1.0420171577660218e+00 - 492 3.5666455681952343e+00 -3.5061609850861215e+00 1.5276480532892851e+00 - 493 -2.2416592732686493e+00 1.2743323477451605e+00 -3.4535947332380661e+00 - 494 -2.5063043912913913e-01 -1.6306933990281340e+00 5.6310172031723518e+00 - 495 2.3589854948440525e+00 2.5421876741753771e+00 3.1695195211973832e+00 - 496 2.2574894820168483e+00 3.6956620104200572e-01 -3.5121218711856717e-01 - 497 -5.0351003329616368e+00 -3.5764874514977008e+00 -4.2176800204027414e+00 - 498 -3.5336727643305421e+00 1.0270508441019970e+00 8.7528194493804667e-01 - 499 -1.7753604141545754e+00 2.1870380688570714e+00 4.0746694362092608e+00 - 500 4.2449410599123993e+00 -4.3834286828818803e+00 3.7646766355563002e+00 - 501 2.7078936465321397e+00 3.1295683628914097e+00 1.7445195155460125e+00 - 502 8.7327387446490479e-01 7.6772540692813085e-01 -3.2402617779281712e-01 - 503 8.1016418773728660e-01 -3.1389885601608358e+00 -3.3633443469808784e+00 - 504 -1.4278855654148510e+00 4.0286484781122276e+00 -1.9992906821384473e+00 - 505 8.6542958084548566e-02 -1.1020400457566535e+00 -3.3822209055940355e-01 - 506 3.5813121257873570e+00 -5.6151617304223689e-01 1.4119734987696160e+00 - 507 3.0606661941208650e+00 1.7089133715354412e+00 -2.8032446787137681e+00 - 508 -1.3854267730385632e+00 -4.4188316872855333e+00 -2.5380111088581714e+00 - 509 -1.6904739442046626e+00 1.8488347785921746e+00 -1.3746204703475671e+00 - 510 -2.2661772905636153e+00 3.3572261480593624e+00 -2.2464258009076454e+00 - 511 5.5268470973310224e+00 -1.7435558018608679e+00 -2.0408474603750189e+00 - 512 4.5886957877184127e+00 4.8319627526991518e+00 3.9643528671273245e+00 + 1 2.2065977620733823e-01 6.8508757018167898e-01 -4.7014971045392834e-01 + 2 -4.0124462717250839e+00 -2.1228312063765733e+00 -9.9897973861188283e-01 + 3 2.9685852583506717e-01 3.7266566877035148e+00 -1.0818658724311632e+00 + 4 8.1961211837120795e-02 -3.5570651112582063e-02 -3.5157302537620492e+00 + 5 -6.2728373866267073e-01 -2.7267744726566687e+00 9.9537775326668565e-01 + 6 -2.9603014594591437e-01 3.9112521689299560e+00 1.7782799262643807e+00 + 7 -2.1400291579006030e+00 -2.8265998306349855e+00 2.4454803567748606e+00 + 8 1.2252665174715598e+00 1.8937900711273328e+00 -3.0560489361858383e+00 + 9 -3.4366253701592160e+00 -3.0728708291251841e+00 -2.8755624856904287e+00 + 10 3.2113319900004017e-01 -2.0408399212555910e+00 -2.4817036798308094e+00 + 11 2.3993994751634742e+00 -5.4038696805398185e+00 2.9783868115053305e+00 + 12 -4.3087336411254045e+00 -5.2637599316271890e+00 -5.2480326020519099e+00 + 13 -2.0320550196331832e-01 4.6412772506323901e+00 -1.5157732877070105e+00 + 14 -1.8439832209648992e+00 4.1540210600591978e+00 7.9344962175590128e-01 + 15 -3.4057213913446360e-01 4.9061723967337816e+00 -2.6145747014412271e+00 + 16 2.1164541985651750e+00 -4.0729732248048311e-01 4.5537682682394198e+00 + 17 4.4954272557720110e+00 3.4922366648719638e+00 -2.2646334656811025e+00 + 18 -3.5506395759279483e+00 1.1009362664654250e+00 2.2848749119147880e+00 + 19 -1.0456337863134406e+00 -2.9724235443270648e+00 -3.1554579860703169e-01 + 20 -3.3313433991320456e+00 3.2426197185600354e+00 4.6572151933457757e+00 + 21 -1.6604128078447267e+00 -5.0401667704388187e-01 -4.3340028890967739e+00 + 22 -5.1780999254441662e+00 3.7656370977861480e+00 -3.8736456354976978e+00 + 23 2.5810691560850296e+00 3.9129419455686310e+00 1.0071952222896108e+00 + 24 1.2189893770300371e+00 1.2902271765990232e+00 -2.1816564738551740e+00 + 25 5.1717608355200118e-01 -2.2766313967227761e-01 4.0357834558791748e+00 + 26 5.5837971079115853e-02 -6.3312910436400516e-01 1.1338376610212455e+00 + 27 2.3776569282085838e+00 -1.3713335058520987e-01 1.8320253886114752e+00 + 28 -7.4605155753871388e-01 6.2639691169773104e-01 7.0950844496935170e+00 + 29 -2.7959006485060733e+00 2.6518449844717753e+00 -4.9418005822869659e+00 + 30 -1.9284812027028364e+00 3.6728996905807461e+00 -1.8903320575690421e+00 + 31 2.7501847555635224e+00 1.1800402620831711e+00 1.0386547735831302e+00 + 32 2.8874286555417883e-01 -8.4184451809623728e-01 -4.5827458970090051e-01 + 33 2.4177527590723296e+00 -4.1799340496126538e+00 4.2734972725104496e+00 + 34 2.9163123188810798e+00 1.1372045084901194e-01 2.4063982964448699e-01 + 35 1.1211713580663796e+00 -4.1852692109665224e+00 2.7055107929805744e+00 + 36 -3.3366806196511511e-01 -2.8592865937324241e+00 -3.6174665813781992e-01 + 37 -4.0598737192925629e+00 1.4790701200934750e+00 -2.0390573716466114e+00 + 38 -1.3972933493773498e+00 -1.5890688842928011e+00 1.2229127903290464e+00 + 39 1.7226829337464571e+00 4.6041363206313723e-01 1.6231271754939940e+00 + 40 4.7487429565043131e+00 -2.0032508711704504e+00 -2.3351656873697735e+00 + 41 -3.0211988899794873e-01 -3.1647229185551078e+00 -3.4484252242803659e-01 + 42 -4.3757968924703796e+00 -1.4988492973802408e+00 3.4848185514124802e-01 + 43 -2.3376048805867390e-02 -5.2171266030795751e+00 1.0422526834227199e+00 + 44 3.5686225189826812e+00 -3.5083544149657571e+00 1.5296762770587249e+00 + 45 -2.2429190678755098e+00 1.2762137613260987e+00 -3.4561335371333506e+00 + 46 -2.5249858397832398e-01 -1.6311993993014708e+00 5.6327007942433953e+00 + 47 2.3600434001454800e+00 2.5432001280052963e+00 3.1710184050148387e+00 + 48 2.2569424883932574e+00 3.6974145225970140e-01 -3.5079037684111325e-01 + 49 -5.0373146177377670e+00 -3.5792639981389867e+00 -4.2214396499888958e+00 + 50 -3.5333518619269704e+00 1.0268969392472456e+00 8.7615872588377397e-01 + 51 -1.7772253346150806e+00 2.1897240981816273e+00 4.0771383097941207e+00 + 52 4.2488265275528541e+00 -4.3879293775874428e+00 3.7692331388491089e+00 + 53 2.7105634024928702e+00 3.1321616846328704e+00 1.7466641233894777e+00 + 54 8.7345045914397412e-01 7.6780961728566233e-01 -3.2428866998030409e-01 + 55 8.1222707163562391e-01 -3.1415725783562616e+00 -3.3658388474832908e+00 + 56 -1.4293980095456800e+00 4.0300936576663196e+00 -2.0006489138695476e+00 + 57 8.6574115148983888e-02 -1.1025347346522771e+00 -3.3832826272726713e-01 + 58 3.5829961754217270e+00 -5.6274174997305004e-01 1.4127528025967375e+00 + 59 3.0632055304618659e+00 1.7103486318850951e+00 -2.8047593712683239e+00 + 60 -1.3875136436687734e+00 -4.4223159472758020e+00 -2.5405244604650332e+00 + 61 -1.6911573920575165e+00 1.8495318348477738e+00 -1.3750758436991020e+00 + 62 -2.2677591075287817e+00 3.3580212813414767e+00 -2.2471871608771177e+00 + 63 5.5289268843361006e+00 -1.7453255640698171e+00 -2.0435451118905243e+00 + 64 4.5908794739248782e+00 4.8343851592710259e+00 3.9665064357692694e+00 + 65 2.2065977620732435e-01 6.8508757018165423e-01 -4.7014971045390386e-01 + 66 -4.0124462717250653e+00 -2.1228312063765440e+00 -9.9897973861186662e-01 + 67 2.9685852583505751e-01 3.7266566877035321e+00 -1.0818658724311438e+00 + 68 8.1961211837130621e-02 -3.5570651112557666e-02 -3.5157302537620594e+00 + 69 -6.2728373866269138e-01 -2.7267744726566736e+00 9.9537775326669231e-01 + 70 -2.9603014594596749e-01 3.9112521689299400e+00 1.7782799262643512e+00 + 71 -2.1400291579005106e+00 -2.8265998306349669e+00 2.4454803567748207e+00 + 72 1.2252665174715947e+00 1.8937900711272986e+00 -3.0560489361858294e+00 + 73 -3.4366253701592071e+00 -3.0728708291251849e+00 -2.8755624856904229e+00 + 74 3.2113319899987847e-01 -2.0408399212556789e+00 -2.4817036798308600e+00 + 75 2.3993994751634551e+00 -5.4038696805398221e+00 2.9783868115053167e+00 + 76 -4.3087336411254489e+00 -5.2637599316272494e+00 -5.2480326020519472e+00 + 77 -2.0320550196332379e-01 4.6412772506323696e+00 -1.5157732877070116e+00 + 78 -1.8439832209647342e+00 4.1540210600592307e+00 7.9344962175599554e-01 + 79 -3.4057213913449891e-01 4.9061723967338429e+00 -2.6145747014412852e+00 + 80 2.1164541985652741e+00 -4.0729732248037820e-01 4.5537682682393807e+00 + 81 4.4954272557720483e+00 3.4922366648720153e+00 -2.2646334656811526e+00 + 82 -3.5506395759279634e+00 1.1009362664654385e+00 2.2848749119147871e+00 + 83 -1.0456337863134775e+00 -2.9724235443270559e+00 -3.1554579860706039e-01 + 84 -3.3313433991320669e+00 3.2426197185600620e+00 4.6572151933457944e+00 + 85 -1.6604128078447038e+00 -5.0401667704390396e-01 -4.3340028890967668e+00 + 86 -5.1780999254441715e+00 3.7656370977861551e+00 -3.8736456354977027e+00 + 87 2.5810691560850523e+00 3.9129419455686567e+00 1.0071952222896203e+00 + 88 1.2189893770300828e+00 1.2902271765989952e+00 -2.1816564738551678e+00 + 89 5.1717608355196276e-01 -2.2766313967224597e-01 4.0357834558791783e+00 + 90 5.5837971079057566e-02 -6.3312910436398295e-01 1.1338376610212304e+00 + 91 2.3776569282084887e+00 -1.3713335058521431e-01 1.8320253886114886e+00 + 92 -7.4605155753866548e-01 6.2639691169766998e-01 7.0950844496934851e+00 + 93 -2.7959006485060511e+00 2.6518449844717504e+00 -4.9418005822869606e+00 + 94 -1.9284812027027982e+00 3.6728996905807318e+00 -1.8903320575690112e+00 + 95 2.7501847555635877e+00 1.1800402620831729e+00 1.0386547735831460e+00 + 96 2.8874286555416040e-01 -8.4184451809625471e-01 -4.5827458970087132e-01 + 97 2.4177527590722883e+00 -4.1799340496126005e+00 4.2734972725103830e+00 + 98 2.9163123188810642e+00 1.1372045084901788e-01 2.4063982964447964e-01 + 99 1.1211713580663827e+00 -4.1852692109665268e+00 2.7055107929805726e+00 + 100 -3.3366806196512105e-01 -2.8592865937324192e+00 -3.6174665813781948e-01 + 101 -4.0598737192925762e+00 1.4790701200934706e+00 -2.0390573716466149e+00 + 102 -1.3972933493773390e+00 -1.5890688842927938e+00 1.2229127903290575e+00 + 103 1.7226829337464682e+00 4.6041363206313601e-01 1.6231271754939924e+00 + 104 4.7487429565043344e+00 -2.0032508711704624e+00 -2.3351656873697602e+00 + 105 -3.0211988899794467e-01 -3.1647229185550834e+00 -3.4484252242802793e-01 + 106 -4.3757968924704223e+00 -1.4988492973802650e+00 3.4848185514121544e-01 + 107 -2.3376048805824369e-02 -5.2171266030795724e+00 1.0422526834227595e+00 + 108 3.5686225189826546e+00 -3.5083544149656913e+00 1.5296762770586798e+00 + 109 -2.2429190678755635e+00 1.2762137613261069e+00 -3.4561335371333839e+00 + 110 -2.5249858397827396e-01 -1.6311993993014295e+00 5.6327007942433740e+00 + 111 2.3600434001454698e+00 2.5432001280052896e+00 3.1710184050148222e+00 + 112 2.2569424883932276e+00 3.6974145225970800e-01 -3.5079037684111525e-01 + 113 -5.0373146177377075e+00 -3.5792639981389738e+00 -4.2214396499888753e+00 + 114 -3.5333518619269451e+00 1.0268969392472418e+00 8.7615872588378296e-01 + 115 -1.7772253346151046e+00 2.1897240981816353e+00 4.0771383097941207e+00 + 116 4.2488265275528576e+00 -4.3879293775874464e+00 3.7692331388491169e+00 + 117 2.7105634024928436e+00 3.1321616846328593e+00 1.7466641233894660e+00 + 118 8.7345045914395758e-01 7.6780961728565911e-01 -3.2428866998030798e-01 + 119 8.1222707163570795e-01 -3.1415725783562989e+00 -3.3658388474833179e+00 + 120 -1.4293980095456700e+00 4.0300936576663116e+00 -2.0006489138695445e+00 + 121 8.6574115149026409e-02 -1.1025347346522691e+00 -3.3832826272724698e-01 + 122 3.5829961754217070e+00 -5.6274174997306403e-01 1.4127528025967464e+00 + 123 3.0632055304618984e+00 1.7103486318850667e+00 -2.8047593712683141e+00 + 124 -1.3875136436688347e+00 -4.4223159472757931e+00 -2.5405244604650492e+00 + 125 -1.6911573920575489e+00 1.8495318348477723e+00 -1.3750758436991293e+00 + 126 -2.2677591075287968e+00 3.3580212813414940e+00 -2.2471871608771297e+00 + 127 5.5289268843360615e+00 -1.7453255640697956e+00 -2.0435451118904822e+00 + 128 4.5908794739248808e+00 4.8343851592710294e+00 3.9665064357692685e+00 + 129 2.2065977620733399e-01 6.8508757018167454e-01 -4.7014971045393039e-01 + 130 -4.0124462717250617e+00 -2.1228312063765644e+00 -9.9897973861187095e-01 + 131 2.9685852583505956e-01 3.7266566877035285e+00 -1.0818658724311603e+00 + 132 8.1961211837090445e-02 -3.5570651112592298e-02 -3.5157302537620549e+00 + 133 -6.2728373866266207e-01 -2.7267744726566501e+00 9.9537775326668165e-01 + 134 -2.9603014594592447e-01 3.9112521689299351e+00 1.7782799262643756e+00 + 135 -2.1400291579006119e+00 -2.8265998306350260e+00 2.4454803567748762e+00 + 136 1.2252665174715807e+00 1.8937900711273210e+00 -3.0560489361858236e+00 + 137 -3.4366253701592004e+00 -3.0728708291251836e+00 -2.8755624856904256e+00 + 138 3.2113319900006487e-01 -2.0408399212555270e+00 -2.4817036798308107e+00 + 139 2.3993994751634760e+00 -5.4038696805398221e+00 2.9783868115053194e+00 + 140 -4.3087336411253938e+00 -5.2637599316271855e+00 -5.2480326020518921e+00 + 141 -2.0320550196332093e-01 4.6412772506323847e+00 -1.5157732877070242e+00 + 142 -1.8439832209649119e+00 4.1540210600591259e+00 7.9344962175592482e-01 + 143 -3.4057213913447748e-01 4.9061723967338047e+00 -2.6145747014412515e+00 + 144 2.1164541985650991e+00 -4.0729732248055028e-01 4.5537682682394323e+00 + 145 4.4954272557720785e+00 3.4922366648720087e+00 -2.2646334656811336e+00 + 146 -3.5506395759279696e+00 1.1009362664654632e+00 2.2848749119148124e+00 + 147 -1.0456337863134513e+00 -2.9724235443270421e+00 -3.1554579860704091e-01 + 148 -3.3313433991320207e+00 3.2426197185600190e+00 4.6572151933457686e+00 + 149 -1.6604128078446929e+00 -5.0401667704393449e-01 -4.3340028890967801e+00 + 150 -5.1780999254441360e+00 3.7656370977861120e+00 -3.8736456354976614e+00 + 151 2.5810691560850336e+00 3.9129419455686074e+00 1.0071952222896006e+00 + 152 1.2189893770300262e+00 1.2902271765990314e+00 -2.1816564738551665e+00 + 153 5.1717608355199707e-01 -2.2766313967227483e-01 4.0357834558791748e+00 + 154 5.5837971079133963e-02 -6.3312910436398928e-01 1.1338376610212486e+00 + 155 2.3776569282086086e+00 -1.3713335058519083e-01 1.8320253886114819e+00 + 156 -7.4605155753865993e-01 6.2639691169766987e-01 7.0950844496935401e+00 + 157 -2.7959006485061026e+00 2.6518449844718162e+00 -4.9418005822869784e+00 + 158 -1.9284812027028533e+00 3.6728996905807429e+00 -1.8903320575690574e+00 + 159 2.7501847555635144e+00 1.1800402620831889e+00 1.0386547735831377e+00 + 160 2.8874286555417567e-01 -8.4184451809624117e-01 -4.5827458970091001e-01 + 161 2.4177527590723455e+00 -4.1799340496126893e+00 4.2734972725104754e+00 + 162 2.9163123188810771e+00 1.1372045084902060e-01 2.4063982964448416e-01 + 163 1.1211713580663814e+00 -4.1852692109665393e+00 2.7055107929805637e+00 + 164 -3.3366806196511456e-01 -2.8592865937323801e+00 -3.6174665813781581e-01 + 165 -4.0598737192925674e+00 1.4790701200934642e+00 -2.0390573716466025e+00 + 166 -1.3972933493773418e+00 -1.5890688842927947e+00 1.2229127903290475e+00 + 167 1.7226829337464684e+00 4.6041363206314684e-01 1.6231271754940000e+00 + 168 4.7487429565043175e+00 -2.0032508711704686e+00 -2.3351656873697832e+00 + 169 -3.0211988899796099e-01 -3.1647229185550936e+00 -3.4484252242803343e-01 + 170 -4.3757968924703894e+00 -1.4988492973802519e+00 3.4848185514123003e-01 + 171 -2.3376048805854945e-02 -5.2171266030795884e+00 1.0422526834227401e+00 + 172 3.5686225189826550e+00 -3.5083544149657140e+00 1.5296762770587022e+00 + 173 -2.2429190678755266e+00 1.2762137613261175e+00 -3.4561335371333590e+00 + 174 -2.5249858397830222e-01 -1.6311993993014464e+00 5.6327007942433953e+00 + 175 2.3600434001454755e+00 2.5432001280052940e+00 3.1710184050148360e+00 + 176 2.2569424883932507e+00 3.6974145225968996e-01 -3.5079037684110964e-01 + 177 -5.0373146177377981e+00 -3.5792639981390417e+00 -4.2214396499889411e+00 + 178 -3.5333518619269650e+00 1.0268969392472225e+00 8.7615872588376031e-01 + 179 -1.7772253346150948e+00 2.1897240981816073e+00 4.0771383097941376e+00 + 180 4.2488265275528398e+00 -4.3879293775873567e+00 3.7692331388490872e+00 + 181 2.7105634024928884e+00 3.1321616846329201e+00 1.7466641233895275e+00 + 182 8.7345045914397823e-01 7.6780961728569319e-01 -3.2428866998029959e-01 + 183 8.1222707163561303e-01 -3.1415725783563042e+00 -3.3658388474832615e+00 + 184 -1.4293980095456353e+00 4.0300936576662263e+00 -2.0006489138695152e+00 + 185 8.6574115148984901e-02 -1.1025347346522825e+00 -3.3832826272727029e-01 + 186 3.5829961754216990e+00 -5.6274174997292847e-01 1.4127528025966907e+00 + 187 3.0632055304618695e+00 1.7103486318851024e+00 -2.8047593712682977e+00 + 188 -1.3875136436688005e+00 -4.4223159472758375e+00 -2.5405244604650630e+00 + 189 -1.6911573920574956e+00 1.8495318348477674e+00 -1.3750758436991164e+00 + 190 -2.2677591075288310e+00 3.3580212813414985e+00 -2.2471871608771572e+00 + 191 5.5289268843360695e+00 -1.7453255640698218e+00 -2.0435451118905417e+00 + 192 4.5908794739248941e+00 4.8343851592710472e+00 3.9665064357693018e+00 + 193 2.2065977620732177e-01 6.8508757018165101e-01 -4.7014971045390719e-01 + 194 -4.0124462717250502e+00 -2.1228312063765382e+00 -9.9897973861185496e-01 + 195 2.9685852583505262e-01 3.7266566877035454e+00 -1.0818658724311427e+00 + 196 8.1961211837097786e-02 -3.5570651112571475e-02 -3.5157302537620616e+00 + 197 -6.2728373866267539e-01 -2.7267744726566523e+00 9.9537775326668376e-01 + 198 -2.9603014594597088e-01 3.9112521689299240e+00 1.7782799262643507e+00 + 199 -2.1400291579005177e+00 -2.8265998306349993e+00 2.4454803567748304e+00 + 200 1.2252665174716113e+00 1.8937900711272890e+00 -3.0560489361858205e+00 + 201 -3.4366253701591956e+00 -3.0728708291251809e+00 -2.8755624856904198e+00 + 202 3.2113319899990000e-01 -2.0408399212556190e+00 -2.4817036798308507e+00 + 203 2.3993994751634578e+00 -5.4038696805398194e+00 2.9783868115053100e+00 + 204 -4.3087336411254391e+00 -5.2637599316272476e+00 -5.2480326020519348e+00 + 205 -2.0320550196332396e-01 4.6412772506323590e+00 -1.5157732877070236e+00 + 206 -1.8439832209647438e+00 4.1540210600591623e+00 7.9344962175601397e-01 + 207 -3.4057213913451267e-01 4.9061723967338668e+00 -2.6145747014413105e+00 + 208 2.1164541985652097e+00 -4.0729732248044204e-01 4.5537682682393914e+00 + 209 4.4954272557721220e+00 3.4922366648720633e+00 -2.2646334656811820e+00 + 210 -3.5506395759279887e+00 1.1009362664654772e+00 2.2848749119148128e+00 + 211 -1.0456337863134837e+00 -2.9724235443270404e+00 -3.1554579860706405e-01 + 212 -3.3313433991320491e+00 3.2426197185600505e+00 4.6572151933457935e+00 + 213 -1.6604128078446749e+00 -5.0401667704395470e-01 -4.3340028890967774e+00 + 214 -5.1780999254441440e+00 3.7656370977861240e+00 -3.8736456354976729e+00 + 215 2.5810691560850549e+00 3.9129419455686381e+00 1.0071952222896086e+00 + 216 1.2189893770300753e+00 1.2902271765990028e+00 -2.1816564738551638e+00 + 217 5.1717608355195643e-01 -2.2766313967224022e-01 4.0357834558791765e+00 + 218 5.5837971079070015e-02 -6.3312910436396785e-01 1.1338376610212360e+00 + 219 2.3776569282085069e+00 -1.3713335058519693e-01 1.8320253886115079e+00 + 220 -7.4605155753861085e-01 6.2639691169761247e-01 7.0950844496935002e+00 + 221 -2.7959006485060791e+00 2.6518449844717868e+00 -4.9418005822869757e+00 + 222 -1.9284812027028138e+00 3.6728996905807301e+00 -1.8903320575690223e+00 + 223 2.7501847555635788e+00 1.1800402620831882e+00 1.0386547735831531e+00 + 224 2.8874286555415263e-01 -8.4184451809625616e-01 -4.5827458970088164e-01 + 225 2.4177527590723056e+00 -4.1799340496126334e+00 4.2734972725104114e+00 + 226 2.9163123188810651e+00 1.1372045084902660e-01 2.4063982964447489e-01 + 227 1.1211713580663849e+00 -4.1852692109665455e+00 2.7055107929805615e+00 + 228 -3.3366806196511983e-01 -2.8592865937323739e+00 -3.6174665813781320e-01 + 229 -4.0598737192925798e+00 1.4790701200934622e+00 -2.0390573716466074e+00 + 230 -1.3972933493773356e+00 -1.5890688842927925e+00 1.2229127903290635e+00 + 231 1.7226829337464800e+00 4.6041363206314612e-01 1.6231271754940013e+00 + 232 4.7487429565043344e+00 -2.0032508711704855e+00 -2.3351656873697806e+00 + 233 -3.0211988899795655e-01 -3.1647229185550732e+00 -3.4484252242802338e-01 + 234 -4.3757968924704258e+00 -1.4988492973802843e+00 3.4848185514119656e-01 + 235 -2.3376048805818568e-02 -5.2171266030795858e+00 1.0422526834227763e+00 + 236 3.5686225189826279e+00 -3.5083544149656456e+00 1.5296762770586625e+00 + 237 -2.2429190678755799e+00 1.2762137613261333e+00 -3.4561335371333888e+00 + 238 -2.5249858397824543e-01 -1.6311993993013938e+00 5.6327007942433767e+00 + 239 2.3600434001454706e+00 2.5432001280052909e+00 3.1710184050148222e+00 + 240 2.2569424883932210e+00 3.6974145225969474e-01 -3.5079037684111503e-01 + 241 -5.0373146177377324e+00 -3.5792639981390222e+00 -4.2214396499889162e+00 + 242 -3.5333518619269380e+00 1.0268969392472143e+00 8.7615872588376464e-01 + 243 -1.7772253346151146e+00 2.1897240981816237e+00 4.0771383097941385e+00 + 244 4.2488265275528496e+00 -4.3879293775873647e+00 3.7692331388490987e+00 + 245 2.7105634024928511e+00 3.1321616846329028e+00 1.7466641233895173e+00 + 246 8.7345045914395836e-01 7.6780961728569264e-01 -3.2428866998030559e-01 + 247 8.1222707163569863e-01 -3.1415725783563513e+00 -3.3658388474832881e+00 + 248 -1.4293980095456251e+00 4.0300936576662192e+00 -2.0006489138695107e+00 + 249 8.6574115149029129e-02 -1.1025347346522740e+00 -3.3832826272724925e-01 + 250 3.5829961754216813e+00 -5.6274174997293747e-01 1.4127528025966929e+00 + 251 3.0632055304618993e+00 1.7103486318850718e+00 -2.8047593712682799e+00 + 252 -1.3875136436688631e+00 -4.4223159472758287e+00 -2.5405244604650763e+00 + 253 -1.6911573920575287e+00 1.8495318348477638e+00 -1.3750758436991428e+00 + 254 -2.2677591075288426e+00 3.3580212813415100e+00 -2.2471871608771661e+00 + 255 5.5289268843360224e+00 -1.7453255640698009e+00 -2.0435451118904995e+00 + 256 4.5908794739248977e+00 4.8343851592710472e+00 3.9665064357692983e+00 + 257 2.2065977620732941e-01 6.8508757018167110e-01 -4.7014971045391796e-01 + 258 -4.0124462717250724e+00 -2.1228312063765689e+00 -9.9897973861188238e-01 + 259 2.9685852583505434e-01 3.7266566877035090e+00 -1.0818658724311474e+00 + 260 8.1961211837135978e-02 -3.5570651112582445e-02 -3.5157302537620394e+00 + 261 -6.2728373866268039e-01 -2.7267744726566638e+00 9.9537775326669742e-01 + 262 -2.9603014594592375e-01 3.9112521689299506e+00 1.7782799262643629e+00 + 263 -2.1400291579006092e+00 -2.8265998306349847e+00 2.4454803567748686e+00 + 264 1.2252665174715418e+00 1.8937900711273350e+00 -3.0560489361858800e+00 + 265 -3.4366253701592124e+00 -3.0728708291251818e+00 -2.8755624856904229e+00 + 266 3.2113319900003767e-01 -2.0408399212556123e+00 -2.4817036798307996e+00 + 267 2.3993994751634831e+00 -5.4038696805398132e+00 2.9783868115053385e+00 + 268 -4.3087336411253823e+00 -5.2637599316271810e+00 -5.2480326020518948e+00 + 269 -2.0320550196331744e-01 4.6412772506323856e+00 -1.5157732877070211e+00 + 270 -1.8439832209648801e+00 4.1540210600592022e+00 7.9344962175594513e-01 + 271 -3.4057213913447049e-01 4.9061723967337834e+00 -2.6145747014412617e+00 + 272 2.1164541985651875e+00 -4.0729732248049783e-01 4.5537682682393914e+00 + 273 4.4954272557719896e+00 3.4922366648719509e+00 -2.2646334656810931e+00 + 274 -3.5506395759279417e+00 1.1009362664654467e+00 2.2848749119148133e+00 + 275 -1.0456337863134686e+00 -2.9724235443270923e+00 -3.1554579860704990e-01 + 276 -3.3313433991320278e+00 3.2426197185599994e+00 4.6572151933457437e+00 + 277 -1.6604128078447160e+00 -5.0401667704387920e-01 -4.3340028890968076e+00 + 278 -5.1780999254442071e+00 3.7656370977861950e+00 -3.8736456354977591e+00 + 279 2.5810691560850652e+00 3.9129419455686545e+00 1.0071952222896858e+00 + 280 1.2189893770300313e+00 1.2902271765990312e+00 -2.1816564738551856e+00 + 281 5.1717608355203271e-01 -2.2766313967228052e-01 4.0357834558791534e+00 + 282 5.5837971079129717e-02 -6.3312910436400760e-01 1.1338376610212428e+00 + 283 2.3776569282085740e+00 -1.3713335058519521e-01 1.8320253886114690e+00 + 284 -7.4605155753871610e-01 6.2639691169773581e-01 7.0950844496935010e+00 + 285 -2.7959006485060862e+00 2.6518449844717629e+00 -4.9418005822869766e+00 + 286 -1.9284812027028417e+00 3.6728996905807465e+00 -1.8903320575690452e+00 + 287 2.7501847555635206e+00 1.1800402620831736e+00 1.0386547735831380e+00 + 288 2.8874286555417988e-01 -8.4184451809622918e-01 -4.5827458970090557e-01 + 289 2.4177527590723296e+00 -4.1799340496126653e+00 4.2734972725104541e+00 + 290 2.9163123188810616e+00 1.1372045084901131e-01 2.4063982964448682e-01 + 291 1.1211713580663807e+00 -4.1852692109665259e+00 2.7055107929805704e+00 + 292 -3.3366806196508991e-01 -2.8592865937324055e+00 -3.6174665813779472e-01 + 293 -4.0598737192925585e+00 1.4790701200934770e+00 -2.0390573716466172e+00 + 294 -1.3972933493773392e+00 -1.5890688842927909e+00 1.2229127903290435e+00 + 295 1.7226829337464613e+00 4.6041363206313329e-01 1.6231271754939749e+00 + 296 4.7487429565043104e+00 -2.0032508711704766e+00 -2.3351656873698632e+00 + 297 -3.0211988899794845e-01 -3.1647229185551105e+00 -3.4484252242803848e-01 + 298 -4.3757968924703503e+00 -1.4988492973802341e+00 3.4848185514129637e-01 + 299 -2.3376048805917350e-02 -5.2171266030795431e+00 1.0422526834226988e+00 + 300 3.5686225189826670e+00 -3.5083544149657531e+00 1.5296762770587127e+00 + 301 -2.2429190678754769e+00 1.2762137613260611e+00 -3.4561335371333071e+00 + 302 -2.5249858397829578e-01 -1.6311993993015041e+00 5.6327007942433376e+00 + 303 2.3600434001454920e+00 2.5432001280053047e+00 3.1710184050148311e+00 + 304 2.2569424883932672e+00 3.6974145225971183e-01 -3.5079037684108039e-01 + 305 -5.0373146177377928e+00 -3.5792639981390089e+00 -4.2214396499889082e+00 + 306 -3.5333518619269384e+00 1.0268969392472114e+00 8.7615872588375443e-01 + 307 -1.7772253346151266e+00 2.1897240981816526e+00 4.0771383097941225e+00 + 308 4.2488265275529011e+00 -4.3879293775874855e+00 3.7692331388491231e+00 + 309 2.7105634024928857e+00 3.1321616846328917e+00 1.7466641233895481e+00 + 310 8.7345045914396779e-01 7.6780961728566777e-01 -3.2428866998030031e-01 + 311 8.1222707163562902e-01 -3.1415725783562807e+00 -3.3658388474833245e+00 + 312 -1.4293980095456613e+00 4.0300936576663045e+00 -2.0006489138695276e+00 + 313 8.6574115148966818e-02 -1.1025347346522749e+00 -3.3832826272726396e-01 + 314 3.5829961754217194e+00 -5.6274174997303006e-01 1.4127528025966833e+00 + 315 3.0632055304618753e+00 1.7103486318850509e+00 -2.8047593712683314e+00 + 316 -1.3875136436687978e+00 -4.4223159472758278e+00 -2.5405244604650568e+00 + 317 -1.6911573920575360e+00 1.8495318348477792e+00 -1.3750758436991246e+00 + 318 -2.2677591075287729e+00 3.3580212813414976e+00 -2.2471871608771155e+00 + 319 5.5289268843361041e+00 -1.7453255640698027e+00 -2.0435451118905217e+00 + 320 4.5908794739248941e+00 4.8343851592710383e+00 3.9665064357692850e+00 + 321 2.2065977620731958e-01 6.8508757018164912e-01 -4.7014971045389981e-01 + 322 -4.0124462717250662e+00 -2.1228312063765467e+00 -9.9897973861187206e-01 + 323 2.9685852583504557e-01 3.7266566877035276e+00 -1.0818658724311265e+00 + 324 8.1961211837145054e-02 -3.5570651112557784e-02 -3.5157302537620483e+00 + 325 -6.2728373866269860e-01 -2.7267744726566718e+00 9.9537775326670286e-01 + 326 -2.9603014594596616e-01 3.9112521689299413e+00 1.7782799262643401e+00 + 327 -2.1400291579005142e+00 -2.8265998306349629e+00 2.4454803567748229e+00 + 328 1.2252665174715800e+00 1.8937900711272995e+00 -3.0560489361858694e+00 + 329 -3.4366253701592036e+00 -3.0728708291251809e+00 -2.8755624856904167e+00 + 330 3.2113319899987736e-01 -2.0408399212556958e+00 -2.4817036798308467e+00 + 331 2.3993994751634653e+00 -5.4038696805398132e+00 2.9783868115053269e+00 + 332 -4.3087336411254276e+00 -5.2637599316272450e+00 -5.2480326020519295e+00 + 333 -2.0320550196332526e-01 4.6412772506323616e+00 -1.5157732877070209e+00 + 334 -1.8439832209647171e+00 4.1540210600592227e+00 7.9344962175604017e-01 + 335 -3.4057213913450601e-01 4.9061723967338473e+00 -2.6145747014413216e+00 + 336 2.1164541985652989e+00 -4.0729732248038819e-01 4.5537682682393461e+00 + 337 4.4954272557720341e+00 3.4922366648720105e+00 -2.2646334656811460e+00 + 338 -3.5506395759279554e+00 1.1009362664654545e+00 2.2848749119148124e+00 + 339 -1.0456337863135057e+00 -2.9724235443270817e+00 -3.1554579860707777e-01 + 340 -3.3313433991320545e+00 3.2426197185600296e+00 4.6572151933457686e+00 + 341 -1.6604128078446965e+00 -5.0401667704389908e-01 -4.3340028890967988e+00 + 342 -5.1780999254442168e+00 3.7656370977862070e+00 -3.8736456354977689e+00 + 343 2.5810691560850914e+00 3.9129419455686771e+00 1.0071952222896947e+00 + 344 1.2189893770300737e+00 1.2902271765990079e+00 -2.1816564738551838e+00 + 345 5.1717608355198685e-01 -2.2766313967224525e-01 4.0357834558791614e+00 + 346 5.5837971079071361e-02 -6.3312910436398895e-01 1.1338376610212340e+00 + 347 2.3776569282084776e+00 -1.3713335058520099e-01 1.8320253886114886e+00 + 348 -7.4605155753866903e-01 6.2639691169767264e-01 7.0950844496934700e+00 + 349 -2.7959006485060667e+00 2.6518449844717411e+00 -4.9418005822869757e+00 + 350 -1.9284812027028029e+00 3.6728996905807318e+00 -1.8903320575690150e+00 + 351 2.7501847555635859e+00 1.1800402620831765e+00 1.0386547735831562e+00 + 352 2.8874286555416440e-01 -8.4184451809624505e-01 -4.5827458970087631e-01 + 353 2.4177527590722883e+00 -4.1799340496126067e+00 4.2734972725103901e+00 + 354 2.9163123188810500e+00 1.1372045084901908e-01 2.4063982964447680e-01 + 355 1.1211713580663856e+00 -4.1852692109665250e+00 2.7055107929805691e+00 + 356 -3.3366806196510224e-01 -2.8592865937324086e+00 -3.6174665813779844e-01 + 357 -4.0598737192925727e+00 1.4790701200934737e+00 -2.0390573716466203e+00 + 358 -1.3972933493773345e+00 -1.5890688842927898e+00 1.2229127903290584e+00 + 359 1.7226829337464711e+00 4.6041363206313263e-01 1.6231271754939733e+00 + 360 4.7487429565043389e+00 -2.0032508711704824e+00 -2.3351656873698436e+00 + 361 -3.0211988899794429e-01 -3.1647229185550865e+00 -3.4484252242802960e-01 + 362 -4.3757968924703956e+00 -1.4988492973802561e+00 3.4848185514126701e-01 + 363 -2.3376048805876765e-02 -5.2171266030795485e+00 1.0422526834227379e+00 + 364 3.5686225189826288e+00 -3.5083544149656833e+00 1.5296762770586578e+00 + 365 -2.2429190678755329e+00 1.2762137613260736e+00 -3.4561335371333461e+00 + 366 -2.5249858397824815e-01 -1.6311993993014644e+00 5.6327007942433225e+00 + 367 2.3600434001454915e+00 2.5432001280053038e+00 3.1710184050148182e+00 + 368 2.2569424883932401e+00 3.6974145225972127e-01 -3.5079037684107833e-01 + 369 -5.0373146177377333e+00 -3.5792639981389955e+00 -4.2214396499888878e+00 + 370 -3.5333518619269193e+00 1.0268969392472043e+00 8.7615872588375687e-01 + 371 -1.7772253346151403e+00 2.1897240981816610e+00 4.0771383097941243e+00 + 372 4.2488265275529082e+00 -4.3879293775874944e+00 3.7692331388491360e+00 + 373 2.7105634024928529e+00 3.1321616846328841e+00 1.7466641233895353e+00 + 374 8.7345045914395492e-01 7.6780961728566688e-01 -3.2428866998030270e-01 + 375 8.1222707163570185e-01 -3.1415725783563140e+00 -3.3658388474833436e+00 + 376 -1.4293980095456515e+00 4.0300936576662982e+00 -2.0006489138695236e+00 + 377 8.6574115149007508e-02 -1.1025347346522656e+00 -3.3832826272724670e-01 + 378 3.5829961754217021e+00 -5.6274174997304049e-01 1.4127528025966869e+00 + 379 3.0632055304619046e+00 1.7103486318850294e+00 -2.8047593712683248e+00 + 380 -1.3875136436688611e+00 -4.4223159472758171e+00 -2.5405244604650710e+00 + 381 -1.6911573920575631e+00 1.8495318348477765e+00 -1.3750758436991477e+00 + 382 -2.2677591075287888e+00 3.3580212813415158e+00 -2.2471871608771270e+00 + 383 5.5289268843360633e+00 -1.7453255640697798e+00 -2.0435451118904799e+00 + 384 4.5908794739248933e+00 4.8343851592710401e+00 3.9665064357692801e+00 + 385 2.2065977620732730e-01 6.8508757018166722e-01 -4.7014971045392268e-01 + 386 -4.0124462717250555e+00 -2.1228312063765657e+00 -9.9897973861187450e-01 + 387 2.9685852583504840e-01 3.7266566877035179e+00 -1.0818658724311452e+00 + 388 8.1961211837107736e-02 -3.5570651112587594e-02 -3.5157302537620403e+00 + 389 -6.2728373866267106e-01 -2.7267744726566456e+00 9.9537775326669231e-01 + 390 -2.9603014594592247e-01 3.9112521689299307e+00 1.7782799262643685e+00 + 391 -2.1400291579006185e+00 -2.8265998306350202e+00 2.4454803567748815e+00 + 392 1.2252665174715607e+00 1.8937900711273177e+00 -3.0560489361858738e+00 + 393 -3.4366253701591964e+00 -3.0728708291251805e+00 -2.8755624856904189e+00 + 394 3.2113319900006382e-01 -2.0408399212555475e+00 -2.4817036798308010e+00 + 395 2.3993994751634857e+00 -5.4038696805398176e+00 2.9783868115053309e+00 + 396 -4.3087336411253752e+00 -5.2637599316271784e+00 -5.2480326020518815e+00 + 397 -2.0320550196332074e-01 4.6412772506323767e+00 -1.5157732877070365e+00 + 398 -1.8439832209648899e+00 4.1540210600591241e+00 7.9344962175597222e-01 + 399 -3.4057213913448170e-01 4.9061723967338047e+00 -2.6145747014412812e+00 + 400 2.1164541985651271e+00 -4.0729732248056127e-01 4.5537682682393967e+00 + 401 4.4954272557720563e+00 3.4922366648719958e+00 -2.2646334656811242e+00 + 402 -3.5506395759279665e+00 1.1009362664654851e+00 2.2848749119148377e+00 + 403 -1.0456337863134848e+00 -2.9724235443270710e+00 -3.1554579860705723e-01 + 404 -3.3313433991320127e+00 3.2426197185599919e+00 4.6572151933457420e+00 + 405 -1.6604128078446829e+00 -5.0401667704393338e-01 -4.3340028890968139e+00 + 406 -5.1780999254441831e+00 3.7656370977861631e+00 -3.8736456354977280e+00 + 407 2.5810691560850709e+00 3.9129419455686327e+00 1.0071952222896738e+00 + 408 1.2189893770300229e+00 1.2902271765990374e+00 -2.1816564738551811e+00 + 409 5.1717608355202493e-01 -2.2766313967227628e-01 4.0357834558791481e+00 + 410 5.5837971079144302e-02 -6.3312910436398984e-01 1.1338376610212491e+00 + 411 2.3776569282085980e+00 -1.3713335058517742e-01 1.8320253886114846e+00 + 412 -7.4605155753866470e-01 6.2639691169767375e-01 7.0950844496935259e+00 + 413 -2.7959006485061177e+00 2.6518449844718095e+00 -4.9418005822869944e+00 + 414 -1.9284812027028573e+00 3.6728996905807429e+00 -1.8903320575690619e+00 + 415 2.7501847555635117e+00 1.1800402620831951e+00 1.0386547735831488e+00 + 416 2.8874286555417711e-01 -8.4184451809623262e-01 -4.5827458970091361e-01 + 417 2.4177527590723411e+00 -4.1799340496126929e+00 4.2734972725104763e+00 + 418 2.9163123188810673e+00 1.1372045084901856e-01 2.4063982964448422e-01 + 419 1.1211713580663871e+00 -4.1852692109665384e+00 2.7055107929805620e+00 + 420 -3.3366806196509108e-01 -2.8592865937323548e+00 -3.6174665813779155e-01 + 421 -4.0598737192925629e+00 1.4790701200934655e+00 -2.0390573716466074e+00 + 422 -1.3972933493773372e+00 -1.5890688842927885e+00 1.2229127903290467e+00 + 423 1.7226829337464706e+00 4.6041363206314223e-01 1.6231271754939771e+00 + 424 4.7487429565043096e+00 -2.0032508711704984e+00 -2.3351656873698792e+00 + 425 -3.0211988899795744e-01 -3.1647229185551016e+00 -3.4484252242803315e-01 + 426 -4.3757968924703610e+00 -1.4988492973802494e+00 3.4848185514128066e-01 + 427 -2.3376048805912597e-02 -5.2171266030795564e+00 1.0422526834227130e+00 + 428 3.5686225189826404e+00 -3.5083544149657007e+00 1.5296762770586887e+00 + 429 -2.2429190678754907e+00 1.2762137613260744e+00 -3.4561335371333111e+00 + 430 -2.5249858397827141e-01 -1.6311993993014784e+00 5.6327007942433411e+00 + 431 2.3600434001454915e+00 2.5432001280053038e+00 3.1710184050148325e+00 + 432 2.2569424883932538e+00 3.6974145225970129e-01 -3.5079037684108455e-01 + 433 -5.0373146177378230e+00 -3.5792639981390653e+00 -4.2214396499889535e+00 + 434 -3.5333518619269375e+00 1.0268969392471847e+00 8.7615872588373778e-01 + 435 -1.7772253346151319e+00 2.1897240981816313e+00 4.0771383097941420e+00 + 436 4.2488265275528887e+00 -4.3879293775874038e+00 3.7692331388491107e+00 + 437 2.7105634024928995e+00 3.1321616846329503e+00 1.7466641233895961e+00 + 438 8.7345045914396979e-01 7.6780961728570341e-01 -3.2428866998029504e-01 + 439 8.1222707163561003e-01 -3.1415725783563109e+00 -3.3658388474832925e+00 + 440 -1.4293980095456116e+00 4.0300936576662076e+00 -2.0006489138694881e+00 + 441 8.6574115148964528e-02 -1.1025347346522822e+00 -3.3832826272726874e-01 + 442 3.5829961754216826e+00 -5.6274174997290771e-01 1.4127528025966316e+00 + 443 3.0632055304618788e+00 1.7103486318850583e+00 -2.8047593712683061e+00 + 444 -1.3875136436688247e+00 -4.4223159472758651e+00 -2.5405244604650830e+00 + 445 -1.6911573920575109e+00 1.8495318348477754e+00 -1.3750758436991375e+00 + 446 -2.2677591075288208e+00 3.3580212813415189e+00 -2.2471871608771536e+00 + 447 5.5289268843360748e+00 -1.7453255640698058e+00 -2.0435451118905412e+00 + 448 4.5908794739249110e+00 4.8343851592710587e+00 3.9665064357693121e+00 + 449 2.2065977620731797e-01 6.8508757018164601e-01 -4.7014971045390314e-01 + 450 -4.0124462717250475e+00 -2.1228312063765427e+00 -9.9897973861186151e-01 + 451 2.9685852583504219e-01 3.7266566877035343e+00 -1.0818658724311292e+00 + 452 8.1961211837113107e-02 -3.5570651112571294e-02 -3.5157302537620505e+00 + 453 -6.2728373866268550e-01 -2.7267744726566483e+00 9.9537775326669620e-01 + 454 -2.9603014594597238e-01 3.9112521689299249e+00 1.7782799262643409e+00 + 455 -2.1400291579005266e+00 -2.8265998306349962e+00 2.4454803567748411e+00 + 456 1.2252665174715962e+00 1.8937900711272895e+00 -3.0560489361858609e+00 + 457 -3.4366253701591862e+00 -3.0728708291251734e+00 -2.8755624856904087e+00 + 458 3.2113319899989845e-01 -2.0408399212556350e+00 -2.4817036798308432e+00 + 459 2.3993994751634680e+00 -5.4038696805398168e+00 2.9783868115053189e+00 + 460 -4.3087336411254116e+00 -5.2637599316272343e+00 -5.2480326020519108e+00 + 461 -2.0320550196333101e-01 4.6412772506323465e+00 -1.5157732877070416e+00 + 462 -1.8439832209647335e+00 4.1540210600591578e+00 7.9344962175605360e-01 + 463 -3.4057213913451534e-01 4.9061723967338651e+00 -2.6145747014413372e+00 + 464 2.1164541985652274e+00 -4.0729732248045536e-01 4.5537682682393479e+00 + 465 4.4954272557720998e+00 3.4922366648720518e+00 -2.2646334656811744e+00 + 466 -3.5506395759279834e+00 1.1009362664654998e+00 2.2848749119148426e+00 + 467 -1.0456337863135143e+00 -2.9724235443270688e+00 -3.1554579860708670e-01 + 468 -3.3313433991320420e+00 3.2426197185600270e+00 4.6572151933457713e+00 + 469 -1.6604128078446627e+00 -5.0401667704395514e-01 -4.3340028890968130e+00 + 470 -5.1780999254441911e+00 3.7656370977861737e+00 -3.8736456354977373e+00 + 471 2.5810691560850989e+00 3.9129419455686594e+00 1.0071952222896923e+00 + 472 1.2189893770300682e+00 1.2902271765990110e+00 -2.1816564738551838e+00 + 473 5.1717608355198452e-01 -2.2766313967224341e-01 4.0357834558791552e+00 + 474 5.5837971079085232e-02 -6.3312910436397274e-01 1.1338376610212360e+00 + 475 2.3776569282084941e+00 -1.3713335058517889e-01 1.8320253886114970e+00 + 476 -7.4605155753861430e-01 6.2639691169761458e-01 7.0950844496934895e+00 + 477 -2.7959006485060907e+00 2.6518449844717762e+00 -4.9418005822869873e+00 + 478 -1.9284812027028182e+00 3.6728996905807305e+00 -1.8903320575690257e+00 + 479 2.7501847555635774e+00 1.1800402620831949e+00 1.0386547735831646e+00 + 480 2.8874286555415751e-01 -8.4184451809624661e-01 -4.5827458970088686e-01 + 481 2.4177527590723020e+00 -4.1799340496126378e+00 4.2734972725104132e+00 + 482 2.9163123188810545e+00 1.1372045084902734e-01 2.4063982964447497e-01 + 483 1.1211713580663913e+00 -4.1852692109665437e+00 2.7055107929805589e+00 + 484 -3.3366806196509163e-01 -2.8592865937323566e+00 -3.6174665813778917e-01 + 485 -4.0598737192925771e+00 1.4790701200934606e+00 -2.0390573716466096e+00 + 486 -1.3972933493773290e+00 -1.5890688842927849e+00 1.2229127903290600e+00 + 487 1.7226829337464831e+00 4.6041363206314256e-01 1.6231271754939769e+00 + 488 4.7487429565043335e+00 -2.0032508711705099e+00 -2.3351656873698663e+00 + 489 -3.0211988899795733e-01 -3.1647229185550767e+00 -3.4484252242802543e-01 + 490 -4.3757968924704000e+00 -1.4988492973802796e+00 3.4848185514124658e-01 + 491 -2.3376048805871998e-02 -5.2171266030795600e+00 1.0422526834227526e+00 + 492 3.5686225189826155e+00 -3.5083544149656434e+00 1.5296762770586498e+00 + 493 -2.2429190678755497e+00 1.2762137613260978e+00 -3.4561335371333484e+00 + 494 -2.5249858397821118e-01 -1.6311993993014249e+00 5.6327007942433198e+00 + 495 2.3600434001454902e+00 2.5432001280053025e+00 3.1710184050148209e+00 + 496 2.2569424883932276e+00 3.6974145225970889e-01 -3.5079037684108527e-01 + 497 -5.0373146177377635e+00 -3.5792639981390502e+00 -4.2214396499889375e+00 + 498 -3.5333518619269140e+00 1.0268969392471858e+00 8.7615872588374821e-01 + 499 -1.7772253346151548e+00 2.1897240981816428e+00 4.0771383097941429e+00 + 500 4.2488265275528976e+00 -4.3879293775874126e+00 3.7692331388491165e+00 + 501 2.7105634024928711e+00 3.1321616846329334e+00 1.7466641233895854e+00 + 502 8.7345045914395414e-01 7.6780961728569797e-01 -3.2428866998030276e-01 + 503 8.1222707163569130e-01 -3.1415725783563553e+00 -3.3658388474833130e+00 + 504 -1.4293980095456063e+00 4.0300936576662059e+00 -2.0006489138694903e+00 + 505 8.6574115149004913e-02 -1.1025347346522696e+00 -3.3832826272724970e-01 + 506 3.5829961754216701e+00 -5.6274174997292259e-01 1.4127528025966396e+00 + 507 3.0632055304618988e+00 1.7103486318850267e+00 -2.8047593712682906e+00 + 508 -1.3875136436688860e+00 -4.4223159472758544e+00 -2.5405244604650981e+00 + 509 -1.6911573920575413e+00 1.8495318348477698e+00 -1.3750758436991610e+00 + 510 -2.2677591075288315e+00 3.3580212813415331e+00 -2.2471871608771616e+00 + 511 5.5289268843360286e+00 -1.7453255640697798e+00 -2.0435451118904946e+00 + 512 4.5908794739249092e+00 4.8343851592710569e+00 3.9665064357693121e+00 ... From 886ad8359eae51a18ee4f3f5f3c3c6b730c0eb8f Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 27 May 2022 20:05:33 -0400 Subject: [PATCH 232/585] use venv instead of virtualenv --- python/install.py | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/python/install.py b/python/install.py index a71a601c42..03b3366ba6 100644 --- a/python/install.py +++ b/python/install.py @@ -62,10 +62,10 @@ shutil.copy(args.lib,'lammps') # create a virtual environment for building the wheel shutil.rmtree('buildwheel',True) try: - txt = subprocess.check_output([sys.executable, '-m', 'virtualenv', 'buildwheel', '-p', sys.executable], stderr=subprocess.STDOUT, shell=False) + txt = subprocess.check_output([sys.executable, '-m', 'venv', 'buildwheel'], stderr=subprocess.STDOUT, shell=False) print(txt.decode('UTF-8')) except subprocess.CalledProcessError as err: - sys.exit("Failed to create a virtualenv: {0}".format(err.output.decode('UTF-8'))) + sys.exit("Failed to create a virtual environment: {0}".format(err.output.decode('UTF-8'))) # now run the commands to build the wheel. those must be in a separate script # and run in subprocess, since this will use the virtual environment and From 5f811f852f12f7332ddc4db8e2177a2c5bd10a9a Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sat, 28 May 2022 04:19:47 -0400 Subject: [PATCH 233/585] stop with detailed parser error message with incorrect potential tables --- src/MOLECULE/angle_table.cpp | 14 ++++---------- src/MOLECULE/bond_table.cpp | 20 +++++--------------- src/MOLECULE/dihedral_table.cpp | 9 +++++---- src/pair_table.cpp | 18 ++++-------------- 4 files changed, 18 insertions(+), 43 deletions(-) diff --git a/src/MOLECULE/angle_table.cpp b/src/MOLECULE/angle_table.cpp index eeb30c4d64..c3959dc898 100644 --- a/src/MOLECULE/angle_table.cpp +++ b/src/MOLECULE/angle_table.cpp @@ -402,26 +402,20 @@ void AngleTable::read_table(Table *tb, char *file, char *keyword) // read a,e,f table values from file - int cerror = 0; reader.skip_line(); for (int i = 0; i < tb->ninput; i++) { - line = reader.next_line(4); + line = reader.next_line(); try { ValueTokenizer values(line); values.next_int(); tb->afile[i] = values.next_double(); tb->efile[i] = values.next_double(); tb->ffile[i] = values.next_double(); - } catch (TokenizerException &) { - ++cerror; + } catch (TokenizerException &e) { + error->one(FLERR, "Error parsing angle table '{}' line {} of {}. {}\nLine was: {}", keyword, + i + 1, tb->ninput, e.what(), line); } } - - // warn if data was read incompletely, e.g. columns were missing - - if (cerror) - error->warning(FLERR, "{} of {} lines in table incomplete or could not be parsed", cerror, - tb->ninput); } /* ---------------------------------------------------------------------- diff --git a/src/MOLECULE/bond_table.cpp b/src/MOLECULE/bond_table.cpp index e1eac7c4c2..7af08a4a08 100644 --- a/src/MOLECULE/bond_table.cpp +++ b/src/MOLECULE/bond_table.cpp @@ -325,20 +325,20 @@ void BondTable::read_table(Table *tb, char *file, char *keyword) // read r,e,f table values from file - int cerror = 0; int r0idx = -1; reader.skip_line(); for (int i = 0; i < tb->ninput; i++) { - line = reader.next_line(4); + line = reader.next_line(); try { ValueTokenizer values(line); values.next_int(); tb->rfile[i] = values.next_double(); tb->efile[i] = values.next_double(); tb->ffile[i] = values.next_double(); - } catch (TokenizerException &) { - ++cerror; + } catch (TokenizerException &e) { + error->one(FLERR, "Error parsing bond table '{}' line {} of {}. {}\nLine was: {}", keyword, + i + 1, tb->ninput, e.what(), line); } if (tb->efile[i] < emin) { @@ -373,21 +373,11 @@ void BondTable::read_table(Table *tb, char *file, char *keyword) if (f > fleft && f > fright) ferror++; } - if (ferror) { + if (ferror) error->warning(FLERR, "{} of {} force values in table are inconsistent with -dE/dr.\n" "WARNING: Should only be flagged at inflection points", ferror, tb->ninput); - } - - // warn if data was read incompletely, e.g. columns were missing - - if (cerror) { - error->warning(FLERR, - "{} of {} lines in table were incomplete or could not be" - " parsed completely", - cerror, tb->ninput); - } } /* ---------------------------------------------------------------------- diff --git a/src/MOLECULE/dihedral_table.cpp b/src/MOLECULE/dihedral_table.cpp index ea0b30cbd5..1a9bc923a7 100644 --- a/src/MOLECULE/dihedral_table.cpp +++ b/src/MOLECULE/dihedral_table.cpp @@ -1020,23 +1020,24 @@ void DihedralTable::read_table(Table *tb, char *file, char *keyword) // read a,e,f table values from file for (int i = 0; i < tb->ninput; i++) { + line = reader.next_line(); try { + ValueTokenizer values(line); if (tb->f_unspecified) { - ValueTokenizer values = reader.next_values(3); values.next_int(); tb->phifile[i] = values.next_double(); tb->efile[i] = values.next_double(); } else { - ValueTokenizer values = reader.next_values(4); values.next_int(); tb->phifile[i] = values.next_double(); tb->efile[i] = values.next_double(); tb->ffile[i] = values.next_double(); } } catch (TokenizerException &e) { - error->one(FLERR, e.what()); + error->one(FLERR, "Error parsing dihedral table '{}' line {} of {}. {}\nLine was: {}", + keyword, i + 1, tb->ninput, e.what(), line); } - } //for (int i = 0; (i < tb->ninput) && fp; i++) { + } } /* ---------------------------------------------------------------------- diff --git a/src/pair_table.cpp b/src/pair_table.cpp index aefe9c4c4f..11bd986822 100644 --- a/src/pair_table.cpp +++ b/src/pair_table.cpp @@ -395,20 +395,18 @@ void PairTable::read_table(Table *tb, char *file, char *keyword) union_int_float_t rsq_lookup; int rerror = 0; - int cerror = 0; - reader.skip_line(); for (int i = 0; i < tb->ninput; i++) { - line = reader.next_line(4); - + line = reader.next_line(); try { ValueTokenizer values(line); values.next_int(); rfile = values.next_double(); tb->efile[i] = conversion_factor * values.next_double(); tb->ffile[i] = conversion_factor * values.next_double(); - } catch (TokenizerException &) { - ++cerror; + } catch (TokenizerException &e) { + error->one(FLERR, "Error parsing pair table '{}' line {} of {}. {}\nLine was: {}", keyword, + i + 1, tb->ninput, e.what(), line); } rnew = rfile; @@ -474,14 +472,6 @@ void PairTable::read_table(Table *tb, char *file, char *keyword) "{} of {} distance values in table {} with relative error\n" "WARNING: over {} to re-computed values", rerror, tb->ninput, EPSILONR, keyword); - - // warn if data was read incompletely, e.g. columns were missing - - if (cerror) - error->warning(FLERR, - "{} of {} lines in table {} were incomplete\n" - "WARNING: or could not be parsed completely", - cerror, tb->ninput, keyword); } /* ---------------------------------------------------------------------- From e2dd08a93e7cb738478e447541ae9d1846df8ad6 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 26 May 2022 21:40:33 -0400 Subject: [PATCH 234/585] Better handle file- or path-names with spaces --- cmake/Modules/generate_lmpgitversion.cmake | 6 ++++-- unittest/formats/compressed_dump_test.h | 2 +- unittest/formats/test_dump_atom.cpp | 2 +- unittest/formats/test_dump_custom.cpp | 2 +- 4 files changed, 7 insertions(+), 5 deletions(-) diff --git a/cmake/Modules/generate_lmpgitversion.cmake b/cmake/Modules/generate_lmpgitversion.cmake index f066269723..32aaf6f2c5 100644 --- a/cmake/Modules/generate_lmpgitversion.cmake +++ b/cmake/Modules/generate_lmpgitversion.cmake @@ -31,5 +31,7 @@ set(temp "${temp}const char *LAMMPS_NS::LAMMPS::git_descriptor() { return \"${te set(temp "${temp}#endif\n\n") message(STATUS "Generating lmpgitversion.h...") -file(WRITE "${LAMMPS_STYLE_HEADERS_DIR}/lmpgitversion.h.tmp" "${temp}" ) -execute_process(COMMAND ${CMAKE_COMMAND} -E copy_if_different "${LAMMPS_STYLE_HEADERS_DIR}/lmpgitversion.h.tmp" "${LAMMPS_STYLE_HEADERS_DIR}/lmpgitversion.h") + +string(REPLACE "\\ " " " LAMMPS_GIT_HEADER "${LAMMPS_STYLE_HEADERS_DIR}/lmpgitversion.h") +file(WRITE "${LAMMPS_GIT_HEADER}.tmp" "${temp}" ) +execute_process(COMMAND ${CMAKE_COMMAND} -E copy_if_different "${LAMMPS_GIT_HEADER}.tmp" "${LAMMPS_GIT_HEADER}") diff --git a/unittest/formats/compressed_dump_test.h b/unittest/formats/compressed_dump_test.h index d9803005e5..b209097264 100644 --- a/unittest/formats/compressed_dump_test.h +++ b/unittest/formats/compressed_dump_test.h @@ -102,7 +102,7 @@ public: BEGIN_HIDE_OUTPUT(); std::string converted_file = compressed_file.substr(0, compressed_file.find_last_of('.')); std::string cmdline = - fmt::format("{} -d -c {} > {}", COMPRESS_EXECUTABLE, compressed_file, converted_file); + fmt::format("\"{}\" -d -c {} > {}", COMPRESS_EXECUTABLE, compressed_file, converted_file); system(cmdline.c_str()); END_HIDE_OUTPUT(); return converted_file; diff --git a/unittest/formats/test_dump_atom.cpp b/unittest/formats/test_dump_atom.cpp index c9e5223f19..d1b22d7827 100644 --- a/unittest/formats/test_dump_atom.cpp +++ b/unittest/formats/test_dump_atom.cpp @@ -100,7 +100,7 @@ public: std::string convert_binary_to_text(std::string binary_file) { BEGIN_HIDE_OUTPUT(); - std::string cmdline = fmt::format("{} {}", BINARY2TXT_EXECUTABLE, binary_file); + std::string cmdline = fmt::format("\"{}\" {}", BINARY2TXT_EXECUTABLE, binary_file); system(cmdline.c_str()); END_HIDE_OUTPUT(); return fmt::format("{}.txt", binary_file); diff --git a/unittest/formats/test_dump_custom.cpp b/unittest/formats/test_dump_custom.cpp index ee297b194e..39cb4ffd27 100644 --- a/unittest/formats/test_dump_custom.cpp +++ b/unittest/formats/test_dump_custom.cpp @@ -100,7 +100,7 @@ public: std::string convert_binary_to_text(std::string binary_file) { BEGIN_HIDE_OUTPUT(); - std::string cmdline = fmt::format("{} {}", BINARY2TXT_EXECUTABLE, binary_file); + std::string cmdline = fmt::format("\"{}\" {}", BINARY2TXT_EXECUTABLE, binary_file); system(cmdline.c_str()); END_HIDE_OUTPUT(); return fmt::format("{}.txt", binary_file); From 3615639bddd7672b32f6aa5b3fe46da9dcacabce Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 27 May 2022 20:05:18 -0400 Subject: [PATCH 235/585] Check for a working internet connection. With this check we only do automatic downloads if the check passes --- cmake/CMakeLists.txt | 66 +++++++++++++++------------ cmake/Modules/LAMMPSUtils.cmake | 17 +++++++ cmake/Modules/Packages/COMPRESS.cmake | 6 ++- 3 files changed, 59 insertions(+), 30 deletions(-) diff --git a/cmake/CMakeLists.txt b/cmake/CMakeLists.txt index cffc854f0f..34b5f1344e 100644 --- a/cmake/CMakeLists.txt +++ b/cmake/CMakeLists.txt @@ -138,6 +138,9 @@ if(MSVC) add_compile_options(/Zc:__cplusplus) add_compile_options(/wd4244) add_compile_options(/wd4267) + if(LAMMPS_EXCEPTIONS) + add_compile_options(/EHsc) + endif() add_compile_definitions(_CRT_SECURE_NO_WARNINGS) endif() @@ -418,18 +421,50 @@ endif() # tweak jpeg library names to avoid linker errors with MinGW cross-compilation set(JPEG_NAMES libjpeg libjpeg-62) find_package(JPEG QUIET) -if((NOT JPEG_FOUND) AND (CMAKE_VERSION VERSION_GREATER_EQUAL 3.16)) +find_package(PNG QUIET) +find_package(ZLIB QUIET) + +check_for_internet_connection(HAVE_INTERNET) + +# if we have a working internet connection. download and build missing libs +if(HAVE_INTERNET AND (CMAKE_VERSION VERSION_GREATER_EQUAL 3.16)) + include(ExternalCMakeProject) + if(NOT JPEG_FOUND) set(LIBJPEG_URL https://sourceforge.net/projects/libjpeg-turbo/files/2.1.3/libjpeg-turbo-2.1.3.tar.gz) set(LIBJPEG_MD5 85244dedeaf06f636a9e7ddea6d236d8) mark_as_advanced(LIBJPEG_URL) mark_as_advanced(LIBJPEG_MD5) - include(ExternalCMakeProject) ExternalCmakeProject(libjpeg ${LIBJPEG_URL} ${LIBJPEG_MD5} libjpeg-turbo . CMakeLists.jpeg) add_library(JPEG::JPEG ALIAS jpeg-static) target_include_directories(lammps PRIVATE "${CMAKE_BINARY_DIR}/_deps/libjpeg-src") target_include_directories(lammps PRIVATE "${CMAKE_BINARY_DIR}/_deps/libjpeg-build") set(JPEG_FOUND TRUE) + endif() + if(NOT ZLIB_FOUND) + set(LIBZ_URL http://prdownloads.sourceforge.net/libpng/zlib-1.2.11.tar.gz) + set(LIBZ_MD5 1c9f62f0778697a09d36121ead88e08e) + mark_as_advanced(LIBZ_URL) + mark_as_advanced(LIBZ_MD5) + ExternalCmakeProject(libz ${LIBZ_URL} ${LIBZ_MD5} zlib . CMakeLists.zlib) + add_library(ZLIB::ZLIB ALIAS zlibstatic) + target_include_directories(lammps PRIVATE "${CMAKE_BINARY_DIR}/_deps/libz-src") + target_include_directories(lammps PRIVATE "${CMAKE_BINARY_DIR}/_deps/libz-build") + set(ZLIB_FOUND TRUE) + set(ZLIB_INCLUDE_DIR "${CMAKE_BINARY_DIR}/_deps/libz-src;${CMAKE_BINARY_DIR}/_deps/libz-build") + endif() + if(NOT PNG_FOUND) + set(LIBPNG_URL http://prdownloads.sourceforge.net/libpng/libpng-1.6.37.tar.gz) + set(LIBPNG_MD5 6c7519f6c75939efa0ed3053197abd54) + mark_as_advanced(LIBPNG_URL) + mark_as_advanced(LIBPNG_MD5) + ExternalCmakeProject(libpng ${LIBPNG_URL} ${LIBPNG_MD5} libpng . CMakeLists.png) + add_library(PNG::PNG ALIAS png_static) + target_include_directories(lammps PRIVATE "${CMAKE_BINARY_DIR}/_deps/libpng-src") + target_include_directories(lammps PRIVATE "${CMAKE_BINARY_DIR}/_deps/libpng-build") + set(PNG_FOUND TRUE) + endif() endif() + option(WITH_JPEG "Enable JPEG support" ${JPEG_FOUND}) if(WITH_JPEG) if(NOT JPEG_FOUND) @@ -444,33 +479,6 @@ if(WITH_JPEG) endif() endif() -find_package(PNG QUIET) -find_package(ZLIB QUIET) -if((NOT ZLIB_FOUND) AND (CMAKE_VERSION VERSION_GREATER_EQUAL 3.16)) - set(LIBZ_URL http://prdownloads.sourceforge.net/libpng/zlib-1.2.11.tar.gz) - set(LIBZ_MD5 1c9f62f0778697a09d36121ead88e08e) - mark_as_advanced(LIBZ_URL) - mark_as_advanced(LIBZ_MD5) - include(ExternalCMakeProject) - ExternalCmakeProject(libz ${LIBZ_URL} ${LIBZ_MD5} zlib . CMakeLists.zlib) - add_library(ZLIB::ZLIB ALIAS zlibstatic) - target_include_directories(lammps PRIVATE "${CMAKE_BINARY_DIR}/_deps/libz-src") - target_include_directories(lammps PRIVATE "${CMAKE_BINARY_DIR}/_deps/libz-build") - set(ZLIB_FOUND TRUE) - set(ZLIB_INCLUDE_DIR "${CMAKE_BINARY_DIR}/_deps/libz-src;${CMAKE_BINARY_DIR}/_deps/libz-build") -endif() -if((NOT PNG_FOUND) AND (CMAKE_VERSION VERSION_GREATER_EQUAL 3.16)) - set(LIBPNG_URL http://prdownloads.sourceforge.net/libpng/libpng-1.6.37.tar.gz) - set(LIBPNG_MD5 6c7519f6c75939efa0ed3053197abd54) - mark_as_advanced(LIBPNG_URL) - mark_as_advanced(LIBPNG_MD5) - include(ExternalCMakeProject) - ExternalCmakeProject(libpng ${LIBPNG_URL} ${LIBPNG_MD5} libpng . CMakeLists.png) - add_library(PNG::PNG ALIAS png_static) - target_include_directories(lammps PRIVATE "${CMAKE_BINARY_DIR}/_deps/libpng-src") - target_include_directories(lammps PRIVATE "${CMAKE_BINARY_DIR}/_deps/libpng-build") - set(PNG_FOUND TRUE) -endif() if(PNG_FOUND AND ZLIB_FOUND) option(WITH_PNG "Enable PNG support" ON) else() diff --git a/cmake/Modules/LAMMPSUtils.cmake b/cmake/Modules/LAMMPSUtils.cmake index 943c3d851e..a6df81fa42 100644 --- a/cmake/Modules/LAMMPSUtils.cmake +++ b/cmake/Modules/LAMMPSUtils.cmake @@ -105,6 +105,23 @@ function(FetchPotentials pkgfolder potfolder) endif() endfunction(FetchPotentials) +# Check and record if we have a working internet connection +function(check_for_internet_connection variable) + message("Checking internet connection... ") + if((CMAKE_SYSTEM_NAME STREQUAL "Windows") AND (NOT CMAKE_CROSSCOMPILING)) + execute_process(COMMAND ping www.google.com -n 2 + OUTPUT_QUIET ERROR_QUIET RESULT_VARIABLE PING_STATUS) + else() + execute_process(COMMAND ping www.google.com -c 2 + OUTPUT_QUIET ERROR_QUIET RESULT_VARIABLE PING_STATUS) + endif() + if(PING_STATUS EQUAL 0) + set(${variable} TRUE PARENT_SCOPE) + else() + set(${variable} FALSE PARENT_SCOPE) + endif() +endfunction(check_for_internet_connection) + # set CMAKE_LINUX_DISTRO and CMAKE_DISTRO_VERSION on Linux if((CMAKE_SYSTEM_NAME STREQUAL "Linux") AND (EXISTS /etc/os-release)) file(STRINGS /etc/os-release distro REGEX "^NAME=") diff --git a/cmake/Modules/Packages/COMPRESS.cmake b/cmake/Modules/Packages/COMPRESS.cmake index d9e2ccf7ad..363ee5b79a 100644 --- a/cmake/Modules/Packages/COMPRESS.cmake +++ b/cmake/Modules/Packages/COMPRESS.cmake @@ -1,5 +1,9 @@ if(NOT ZLIB_FOUND) - find_package(ZLIB REQUIRED) + find_package(ZLIB) + if(NOT ZLIB_FOUND) + message(WARNING "zlib library not found skipping COMPRESS package") + return() + endif() endif() target_link_libraries(lammps PRIVATE ZLIB::ZLIB) From d0edd7129c801a683da11fb130e8488f58ceae56 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sat, 28 May 2022 04:54:01 -0400 Subject: [PATCH 236/585] update workflows --- .github/workflows/codeql-analysis.yml | 2 ++ .github/workflows/compile-msvc.yml | 6 ++-- .github/workflows/unittest-gcc.yml | 50 +++++++++++++++++++++++++++ .github/workflows/unittest-macos.yml | 2 ++ 4 files changed, 58 insertions(+), 2 deletions(-) create mode 100644 .github/workflows/unittest-gcc.yml diff --git a/.github/workflows/codeql-analysis.yml b/.github/workflows/codeql-analysis.yml index f9503e0e1f..7ea31fcf14 100644 --- a/.github/workflows/codeql-analysis.yml +++ b/.github/workflows/codeql-analysis.yml @@ -5,6 +5,8 @@ on: push: branches: [develop] + workflow_dispatch: + jobs: analyze: name: Analyze diff --git a/.github/workflows/compile-msvc.yml b/.github/workflows/compile-msvc.yml index b31c262e32..405bb46ae6 100644 --- a/.github/workflows/compile-msvc.yml +++ b/.github/workflows/compile-msvc.yml @@ -3,12 +3,14 @@ name: "Native Windows Compilation and Unit Tests" on: push: - branches: [develop] + branches: [collected-small-changes] + + workflow_dispatch: jobs: build: name: Windows Compilation Test - if: ${{ github.repository == 'lammps/lammps' }} + if: ${{ github.repository == 'akohlmey/lammps' }} runs-on: windows-latest steps: diff --git a/.github/workflows/unittest-gcc.yml b/.github/workflows/unittest-gcc.yml new file mode 100644 index 0000000000..a8dcdff07d --- /dev/null +++ b/.github/workflows/unittest-gcc.yml @@ -0,0 +1,50 @@ +# GitHub action to build LAMMPS on Windows with GCC and Ninja +name: "Native Windows Compilation /w GCC and Unit Tests using Ninja" + +on: + push: + branches: [collected-small-changes] + +jobs: + build: + name: Windows Compilation Test + if: ${{ github.repository == 'akohlmey/lammps' }} + runs-on: windows-latest + + steps: + - name: Checkout repository + uses: actions/checkout@v2 + with: + fetch-depth: 2 + + - name: Select Python version + uses: actions/setup-python@v2 + with: + python-version: '3.10' + + - name: Building LAMMPS via CMake + shell: bash + run: | + choco install ninja + python3 -m pip install numpy + python3 -m pip install pyyaml + cmake -C cmake/presets/windows.cmake \ + -D PKG_PYTHON=on \ + -S cmake -B build \ + -D BUILD_SHARED_LIBS=on \ + -D LAMMPS_EXCEPTIONS=on \ + -D ENABLE_TESTING=on \ + -D CMAKE_BUILD_TYPE=Release \ + -G Ninja + cmake --build build + + - name: Run LAMMPS executable + shell: bash + run: | + ./build/lmp.exe -h + ./build/lmp.exe -in bench/in.lj + + - name: Run Unit Tests + working-directory: build + shell: bash + run: ctest -V diff --git a/.github/workflows/unittest-macos.yml b/.github/workflows/unittest-macos.yml index a222380f60..2d903af646 100644 --- a/.github/workflows/unittest-macos.yml +++ b/.github/workflows/unittest-macos.yml @@ -5,6 +5,8 @@ on: push: branches: [develop] + workflow_dispatch: + jobs: build: name: MacOS Unit Test From 14a9d34838c76cc0f437bc20d0bfacda7cee938c Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sat, 28 May 2022 05:57:06 -0400 Subject: [PATCH 237/585] fix compilation issues --- src/AMOEBA/amoeba_file.cpp | 2 +- src/AMOEBA/amoeba_multipole.cpp | 8 +-- src/AMOEBA/atom_vec_amoeba.cpp | 102 ++++++++++++++------------------ 3 files changed, 50 insertions(+), 62 deletions(-) diff --git a/src/AMOEBA/amoeba_file.cpp b/src/AMOEBA/amoeba_file.cpp index f3266b35d9..70f2196d7c 100644 --- a/src/AMOEBA/amoeba_file.cpp +++ b/src/AMOEBA/amoeba_file.cpp @@ -610,7 +610,7 @@ int PairAmoeba::read_section_line(FILE *fp, char *line, char *ptr,*copy,*copy_next; char **words,**words_next; - int nwords_next; + int nwords, nwords_next; copy = copy_next = NULL; words = words_next = NULL; diff --git a/src/AMOEBA/amoeba_multipole.cpp b/src/AMOEBA/amoeba_multipole.cpp index 58264bb6db..9532f3d7fd 100644 --- a/src/AMOEBA/amoeba_multipole.cpp +++ b/src/AMOEBA/amoeba_multipole.cpp @@ -61,13 +61,13 @@ void PairAmoeba::multipole() // owned atoms - int nlocal = atom->nlocal; + const int nlocal = atom->nlocal; // zero repulsion torque on owned + ghost atoms - int nall = nlocal + atom->nghost; + const int nall = nlocal + atom->nghost; - for (i = 0; i < nall; i++) { + for (int i = 0; i < nall; i++) { tq[i][0] = 0.0; tq[i][1] = 0.0; tq[i][2] = 0.0; @@ -90,7 +90,7 @@ void PairAmoeba::multipole() term = 2.0 * aewald * aewald; fterm = -felec * aewald / MY_PIS; - for (i = 0; i < nlocal; i++) { + for (int i = 0; i < nlocal; i++) { ci = rpole[i][0]; dix = rpole[i][1]; diy = rpole[i][2]; diff --git a/src/AMOEBA/atom_vec_amoeba.cpp b/src/AMOEBA/atom_vec_amoeba.cpp index 6c782a382b..b84ca7ab1e 100644 --- a/src/AMOEBA/atom_vec_amoeba.cpp +++ b/src/AMOEBA/atom_vec_amoeba.cpp @@ -32,47 +32,33 @@ AtomVecAmoeba::AtomVecAmoeba(LAMMPS *lmp) : AtomVec(lmp) // order of fields in a string does not matter // except: fields_data_atom & fields_data_vel must match data file - fields_grow = (char *) - "q molecule num_bond bond_type bond_atom " - "num_angle angle_type angle_atom1 angle_atom2 angle_atom3 " - "num_dihedral dihedral_type dihedral_atom1 dihedral_atom2 " - "dihedral_atom3 dihedral_atom4 " - "num_improper improper_type improper_atom1 improper_atom2 " - "improper_atom3 improper_atom4 " - "nspecial special nspecial15 special15"; - fields_copy = (char *) - "q molecule num_bond bond_type bond_atom " - "num_angle angle_type angle_atom1 angle_atom2 angle_atom3 " - "num_dihedral dihedral_type dihedral_atom1 dihedral_atom2 " - "dihedral_atom3 dihedral_atom4 " - "num_improper improper_type improper_atom1 improper_atom2 " - "improper_atom3 improper_atom4 " - "nspecial special nspecial15 special15"; - fields_comm = (char *) ""; - fields_comm_vel = (char *) ""; - fields_reverse = (char *) ""; - fields_border = (char *) "q molecule"; - fields_border_vel = (char *) "q molecule"; - fields_exchange = (char *) - "q molecule num_bond bond_type bond_atom " - "num_angle angle_type angle_atom1 angle_atom2 angle_atom3 " - "num_dihedral dihedral_type dihedral_atom1 dihedral_atom2 " - "dihedral_atom3 dihedral_atom4 " - "num_improper improper_type improper_atom1 improper_atom2 " - "improper_atom3 improper_atom4 " - "nspecial special nspecial15 special15"; - fields_restart = (char *) - "q molecule num_bond bond_type bond_atom " - "num_angle angle_type angle_atom1 angle_atom2 angle_atom3 " - "num_dihedral dihedral_type dihedral_atom1 dihedral_atom2 " - "dihedral_atom3 dihedral_atom4 " - "num_improper improper_type improper_atom1 improper_atom2 " - "improper_atom3 improper_atom4"; - fields_create = (char *) - "q molecule num_bond num_angle num_dihedral num_improper nspecial nspecial15"; - fields_data_atom = (char *) "id molecule type q x"; - fields_data_vel = (char *) "id v"; - + // clang-format off + fields_grow = {"q", "molecule", "num_bond", "bond_type", "bond_atom", "num_angle", "angle_type", + "angle_atom1", "angle_atom2", "angle_atom3", "num_dihedral", "dihedral_type", "dihedral_atom1", + "dihedral_atom2", "dihedral_atom3", "dihedral_atom4", "num_improper", "improper_type", + "improper_atom1", "improper_atom2", "improper_atom3", "improper_atom4", "nspecial", "special", + "nspecial15", "special15"}; + fields_copy = {"q", "molecule", "num_bond", "bond_type", "bond_atom", "num_angle", "angle_type", + "angle_atom1", "angle_atom2", "angle_atom3", "num_dihedral", "dihedral_type", "dihedral_atom1", + "dihedral_atom2", "dihedral_atom3", "dihedral_atom4", "num_improper", "improper_type", + "improper_atom1", "improper_atom2", "improper_atom3", "improper_atom4", "nspecial", "special", + "nspecial15", "special15"}; + fields_border = {"q", "molecule"}; + fields_border_vel = {"q", "molecule"}; + fields_exchange = {"q", "molecule", "num_bond", "bond_type", "bond_atom", "num_angle", + "angle_type", "angle_atom1", "angle_atom2", "angle_atom3", "num_dihedral", "dihedral_type", + "dihedral_atom1", "dihedral_atom2", "dihedral_atom3", "dihedral_atom4", "num_improper", + "improper_type", "improper_atom1", "improper_atom2", "improper_atom3", "improper_atom4", + "nspecial", "special", "nspecial15", "special15"}; + fields_restart = {"q", "molecule", "num_bond", "bond_type", "bond_atom", "num_angle", + "angle_type", "angle_atom1", "angle_atom2", "angle_atom3", "num_dihedral", "dihedral_type", + "dihedral_atom1", "dihedral_atom2", "dihedral_atom3", "dihedral_atom4", "num_improper", + "improper_type", "improper_atom1", "improper_atom2", "improper_atom3", "improper_atom4"}; + fields_create = {"q", "molecule", "num_bond", "num_angle", "num_dihedral", "num_improper", + "nspecial", "nspecial15"}; + fields_data_atom = {"id", "molecule", "type", "q", "x"}; + fields_data_vel = {"id", "v"}; + // clang-format on setup_fields(); bond_per_atom = angle_per_atom = dihedral_per_atom = improper_per_atom = 0; @@ -83,10 +69,10 @@ AtomVecAmoeba::AtomVecAmoeba(LAMMPS *lmp) : AtomVec(lmp) AtomVecAmoeba::~AtomVecAmoeba() { - delete [] bond_negative; - delete [] angle_negative; - delete [] dihedral_negative; - delete [] improper_negative; + delete[] bond_negative; + delete[] angle_negative; + delete[] dihedral_negative; + delete[] improper_negative; } /* ---------------------------------------------------------------------- @@ -117,22 +103,22 @@ void AtomVecAmoeba::pack_restart_pre(int ilocal) // insure negative vectors are needed length if (bond_per_atom < atom->bond_per_atom) { - delete [] bond_negative; + delete[] bond_negative; bond_per_atom = atom->bond_per_atom; bond_negative = new int[bond_per_atom]; } if (angle_per_atom < atom->angle_per_atom) { - delete [] angle_negative; + delete[] angle_negative; angle_per_atom = atom->angle_per_atom; angle_negative = new int[angle_per_atom]; } if (dihedral_per_atom < atom->dihedral_per_atom) { - delete [] dihedral_negative; + delete[] dihedral_negative; dihedral_per_atom = atom->dihedral_per_atom; dihedral_negative = new int[dihedral_per_atom]; } if (improper_per_atom < atom->improper_per_atom) { - delete [] improper_negative; + delete[] improper_negative; improper_per_atom = atom->improper_per_atom; improper_negative = new int[improper_per_atom]; } @@ -145,7 +131,8 @@ void AtomVecAmoeba::pack_restart_pre(int ilocal) bond_negative[m] = 1; bond_type[ilocal][m] = -bond_type[ilocal][m]; any_bond_negative = 1; - } else bond_negative[m] = 0; + } else + bond_negative[m] = 0; } any_angle_negative = 0; @@ -154,7 +141,8 @@ void AtomVecAmoeba::pack_restart_pre(int ilocal) angle_negative[m] = 1; angle_type[ilocal][m] = -angle_type[ilocal][m]; any_angle_negative = 1; - } else angle_negative[m] = 0; + } else + angle_negative[m] = 0; } any_dihedral_negative = 0; @@ -163,7 +151,8 @@ void AtomVecAmoeba::pack_restart_pre(int ilocal) dihedral_negative[m] = 1; dihedral_type[ilocal][m] = -dihedral_type[ilocal][m]; any_dihedral_negative = 1; - } else dihedral_negative[m] = 0; + } else + dihedral_negative[m] = 0; } any_improper_negative = 0; @@ -172,7 +161,8 @@ void AtomVecAmoeba::pack_restart_pre(int ilocal) improper_negative[m] = 1; improper_type[ilocal][m] = -improper_type[ilocal][m]; any_improper_negative = 1; - } else improper_negative[m] = 0; + } else + improper_negative[m] = 0; } } @@ -196,14 +186,12 @@ void AtomVecAmoeba::pack_restart_post(int ilocal) if (any_dihedral_negative) { for (int m = 0; m < num_dihedral[ilocal]; m++) - if (dihedral_negative[m]) - dihedral_type[ilocal][m] = -dihedral_type[ilocal][m]; + if (dihedral_negative[m]) dihedral_type[ilocal][m] = -dihedral_type[ilocal][m]; } if (any_improper_negative) { for (int m = 0; m < num_improper[ilocal]; m++) - if (improper_negative[m]) - improper_type[ilocal][m] = -improper_type[ilocal][m]; + if (improper_negative[m]) improper_type[ilocal][m] = -improper_type[ilocal][m]; } } From a8eb248b1e3528ff1c026e7182a0943a285c6bb3 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sat, 28 May 2022 06:43:05 -0400 Subject: [PATCH 238/585] reduce compiler warnings. avoid uninitialized data access. consolidate labeling --- src/AMOEBA/amoeba_charge_transfer.cpp | 2 +- src/AMOEBA/amoeba_convolution.cpp | 99 ++++++++------ src/AMOEBA/amoeba_dispersion.cpp | 8 +- src/AMOEBA/amoeba_file.cpp | 58 ++++---- src/AMOEBA/amoeba_induce.cpp | 46 +++---- src/AMOEBA/amoeba_kspace.cpp | 4 +- src/AMOEBA/amoeba_multipole.cpp | 4 +- src/AMOEBA/amoeba_polar.cpp | 47 +++---- src/AMOEBA/amoeba_repulsion.cpp | 10 +- src/AMOEBA/amoeba_utils.cpp | 19 +-- src/AMOEBA/angle_amoeba.cpp | 14 +- src/AMOEBA/fix_amoeba_bitorsion.cpp | 29 ++-- src/AMOEBA/fix_amoeba_pitorsion.cpp | 18 +-- src/AMOEBA/pair_amoeba.cpp | 182 +++++++++++--------------- src/AMOEBA/pair_amoeba.h | 12 +- src/AMOEBA/pair_hippo.cpp | 4 +- 16 files changed, 244 insertions(+), 312 deletions(-) diff --git a/src/AMOEBA/amoeba_charge_transfer.cpp b/src/AMOEBA/amoeba_charge_transfer.cpp index 669ec13194..0c2166d8c8 100644 --- a/src/AMOEBA/amoeba_charge_transfer.cpp +++ b/src/AMOEBA/amoeba_charge_transfer.cpp @@ -29,7 +29,7 @@ enum{VDWL,REPULSE,QFER,DISP,MPOLE,POLAR,USOLV,DISP_LONG,MPOLE_LONG,POLAR_LONG}; void PairAmoeba::charge_transfer() { int i,j,ii,jj,itype,jtype,iclass,jclass; - double e,de,felec,fgrp; + double e,de,felec; double rr1,r,r2; double r3,r4,r5; double xi,yi,zi; diff --git a/src/AMOEBA/amoeba_convolution.cpp b/src/AMOEBA/amoeba_convolution.cpp index eeeaa66053..9c8f728f99 100644 --- a/src/AMOEBA/amoeba_convolution.cpp +++ b/src/AMOEBA/amoeba_convolution.cpp @@ -25,15 +25,15 @@ using namespace LAMMPS_NS; // DEBUG -#define DEBUG 0 - +#define DEBUG_AMOEBA 0 +#if DEBUG_AMOEBA char *labels[7] = {(char *) "MPOLE_GRID", (char *) "POLAR_GRID", (char *) "POLAR_GRIDC", (char *) "DISP_GRID", (char *) "INDUCE_GRID", (char *) "INDUCE_GRIDC"}; enum{GRIDBRICK_OUT,GRIDBRICK_IN,FFT,CFFT1,CFFT2}; - +#endif // END DEBUG enum{MPOLE_GRID,POLAR_GRID,POLAR_GRIDC,DISP_GRID,INDUCE_GRID,INDUCE_GRIDC}; @@ -321,13 +321,17 @@ FFT_SCALAR *AmoebaConvolution::pre_convolution_3d() // reverse comm for 3d brick grid + ghosts - if (DEBUG) debug_scalar(GRIDBRICK_OUT,"PRE Convo / PRE GridComm"); +#if DEBUG_AMOEBA + debug_scalar(GRIDBRICK_OUT,"PRE Convo / PRE GridComm"); +#endif gc->reverse_comm(GridComm::PAIR,amoeba,1,sizeof(FFT_SCALAR),which, gc_buf1,gc_buf2,MPI_FFT_SCALAR); - if (DEBUG) debug_scalar(GRIDBRICK_IN,"PRE Convo / POST GridComm"); - if (DEBUG) debug_file(GRIDBRICK_IN,"pre.convo.post.gridcomm"); +#if DEBUG_AMOEBA + debug_scalar(GRIDBRICK_IN,"PRE Convo / POST GridComm"); + debug_file(GRIDBRICK_IN,"pre.convo.post.gridcomm"); +#endif // copy owned 3d brick grid values to FFT grid @@ -341,8 +345,10 @@ FFT_SCALAR *AmoebaConvolution::pre_convolution_3d() remap->perform(grid_fft,grid_fft,remap_buf); - if (DEBUG) debug_scalar(FFT,"PRE Convo / POST Remap"); - if (DEBUG) debug_file(FFT,"pre.convo.post.remap"); +#if DEBUG_AMOEBA + debug_scalar(FFT,"PRE Convo / POST Remap"); + debug_file(FFT,"pre.convo.post.remap"); +#endif // copy real values into complex grid @@ -361,9 +367,10 @@ FFT_SCALAR *AmoebaConvolution::pre_convolution_3d() for (int i = 0; i < 2*nfft_owned; i++) cfft[i] *= scale; } - if (DEBUG) debug_scalar(CFFT1,"PRE Convo / POST FFT"); - if (DEBUG) debug_file(CFFT1,"pre.convo.post.fft"); - +#if DEBUG_AMOEBA + debug_scalar(CFFT1,"PRE Convo / POST FFT"); + debug_file(CFFT1,"pre.convo.post.fft"); +#endif return cfft; } @@ -377,14 +384,17 @@ FFT_SCALAR *AmoebaConvolution::pre_convolution_4d() // reverse comm for 4d brick grid + ghosts - if (DEBUG) debug_scalar(GRIDBRICK_OUT,"PRE Convo / PRE GridComm"); +#if DEBUG_AMOEBA + debug_scalar(GRIDBRICK_OUT,"PRE Convo / PRE GridComm"); +#endif gc->reverse_comm(GridComm::PAIR,amoeba,2,sizeof(FFT_SCALAR),which, gc_buf1,gc_buf2,MPI_FFT_SCALAR); - if (DEBUG) debug_scalar(GRIDBRICK_IN,"PRE Convo / POST GridComm"); - if (DEBUG) debug_file(GRIDBRICK_IN,"pre.convo.post.gridcomm"); - +#if DEBUG_AMOEBA + debug_scalar(GRIDBRICK_IN,"PRE Convo / POST GridComm"); + debug_file(GRIDBRICK_IN,"pre.convo.post.gridcomm"); +#endif // copy owned 4d brick grid values to FFT grid n = 0; @@ -400,9 +410,10 @@ FFT_SCALAR *AmoebaConvolution::pre_convolution_4d() remap->perform(cfft,cfft,remap_buf); - if (DEBUG) debug_scalar(FFT,"PRE Convo / POST Remap"); - if (DEBUG) debug_file(FFT,"pre.convo.post.remap"); - +#if DEBUG_AMOEBA + debug_scalar(FFT,"PRE Convo / POST Remap"); + debug_file(FFT,"pre.convo.post.remap"); +#endif // perform forward FFT fft1->compute(cfft,cfft,FFT3d::FORWARD); @@ -412,9 +423,10 @@ FFT_SCALAR *AmoebaConvolution::pre_convolution_4d() for (int i = 0; i < 2*nfft_owned; i++) cfft[i] *= scale; } - if (DEBUG) debug_scalar(CFFT1,"PRE Convo / POST FFT"); - if (DEBUG) debug_file(CFFT1,"pre.convo.post.fft"); - +#if DEBUG_AMOEBA + debug_scalar(CFFT1,"PRE Convo / POST FFT"); + debug_file(CFFT1,"pre.convo.post.fft"); +#endif return cfft; } @@ -439,15 +451,16 @@ void *AmoebaConvolution::post_convolution_3d() int ix,iy,iz,n; // perform backward FFT - - if (DEBUG) debug_scalar(CFFT1,"POST Convo / PRE FFT"); - if (DEBUG) debug_file(CFFT1,"post.convo.pre.fft"); - +#if DEBUG_AMOEBA + debug_scalar(CFFT1,"POST Convo / PRE FFT"); + debug_file(CFFT1,"post.convo.pre.fft"); +#endif fft2->compute(cfft,cfft,FFT3d::BACKWARD); - if (DEBUG) debug_scalar(CFFT2,"POST Convo / POST FFT"); - if (DEBUG) debug_file(CFFT2,"post.convo.post.fft"); - +#if DEBUG_AMOEBA + debug_scalar(CFFT2,"POST Convo / POST FFT"); + debug_file(CFFT2,"post.convo.post.fft"); +#endif // copy real portion of 1d complex values into 3d real grid n = 0; @@ -460,9 +473,10 @@ void *AmoebaConvolution::post_convolution_3d() // forward comm to populate ghost grid values - if (DEBUG) debug_scalar(GRIDBRICK_IN,"POST Convo / PRE gridcomm"); - if (DEBUG) debug_file(GRIDBRICK_IN,"post.convo.pre.gridcomm"); - +#if DEBUG_AMOEBA + debug_scalar(GRIDBRICK_IN,"POST Convo / PRE gridcomm"); + debug_file(GRIDBRICK_IN,"post.convo.pre.gridcomm"); +#endif gc->forward_comm(GridComm::PAIR,amoeba,1,sizeof(FFT_SCALAR),which, gc_buf1,gc_buf2,MPI_FFT_SCALAR); @@ -479,14 +493,16 @@ void *AmoebaConvolution::post_convolution_4d() // perform backward FFT - if (DEBUG) debug_scalar(CFFT1,"POST Convo / PRE FFT"); - if (DEBUG) debug_file(CFFT1,"post.convo.pre.fft"); - +#if DEBUG_AMOEBA + debug_scalar(CFFT1,"POST Convo / PRE FFT"); + debug_file(CFFT1,"post.convo.pre.fft"); +#endif fft2->compute(cfft,cfft,FFT3d::BACKWARD); - if (DEBUG) debug_scalar(CFFT2,"POST Convo / POST FFT"); - if (DEBUG) debug_file(CFFT2,"post.convo.post.fft"); - +#if DEBUG_AMOEBA + debug_scalar(CFFT2,"POST Convo / POST FFT"); + debug_file(CFFT2,"post.convo.post.fft"); +#endif // copy 1d complex values into 4d complex grid n = 0; @@ -499,9 +515,10 @@ void *AmoebaConvolution::post_convolution_4d() // forward comm to populate ghost grid values - if (DEBUG) debug_scalar(GRIDBRICK_IN,"POST Convo / PRE gridcomm"); - if (DEBUG) debug_file(GRIDBRICK_IN,"post.convo.pre.gridcomm"); - +#if DEBUG_AMOEBA + debug_scalar(GRIDBRICK_IN,"POST Convo / PRE gridcomm"); + debug_file(GRIDBRICK_IN,"post.convo.pre.gridcomm"); +#endif gc->forward_comm(GridComm::PAIR,amoeba,2,sizeof(FFT_SCALAR),which, gc_buf1,gc_buf2,MPI_FFT_SCALAR); @@ -570,6 +587,7 @@ void AmoebaConvolution::procs2grid2d(int nprocs, int nx, int ny, int &px, int &p } } +#if DEBUG_AMOEBA /* ---------------------------------------------------------------------- output a scalar value to screen array = which array is being summed over @@ -820,3 +838,4 @@ void AmoebaConvolution::debug_file(int array, const char *label) memory->destroy(buf); memory->destroy(buf2); } +#endif diff --git a/src/AMOEBA/amoeba_dispersion.cpp b/src/AMOEBA/amoeba_dispersion.cpp index f79acdc623..febc475322 100644 --- a/src/AMOEBA/amoeba_dispersion.cpp +++ b/src/AMOEBA/amoeba_dispersion.cpp @@ -15,6 +15,7 @@ #include "amoeba_convolution.h" #include "atom.h" +#include "comm.h" #include "domain.h" #include "neigh_list.h" #include "fft3d_wrap.h" @@ -246,10 +247,6 @@ void PairAmoeba::dispersion_kspace() int i,j,k,m,n,ib,jb,kb,itype,iclass; int nhalf1,nhalf2,nhalf3; int nxlo,nxhi,nylo,nyhi,nzlo,nzhi; - int i0,iatm,igrd0; - int it1,it2,it3; - int j0,jgrd0; - int k0,kgrd0; double e,fi,denom,scale; double r1,r2,r3; double h1,h2,h3; @@ -372,7 +369,6 @@ void PairAmoeba::dispersion_kspace() // get first derivatives of the reciprocal space energy int nlpts = (bsorder-1) / 2; - int nrpts = bsorder - nlpts - 1; for (m = 0; m < nlocal; m++) { itype = amtype[m]; @@ -414,7 +410,7 @@ void PairAmoeba::dispersion_kspace() term = csixpr * aewald*aewald*aewald / denom0; - if (me == 0) { + if (comm->me == 0) { edisp -= term; if (vflag_global) { virdisp[0] -= term; diff --git a/src/AMOEBA/amoeba_file.cpp b/src/AMOEBA/amoeba_file.cpp index 70f2196d7c..cac59d12b8 100644 --- a/src/AMOEBA/amoeba_file.cpp +++ b/src/AMOEBA/amoeba_file.cpp @@ -187,8 +187,8 @@ void PairAmoeba::read_prmfile(char *filename) else if (section == QTRANSFER) file_charge_transfer(nwords,words); else if (section == UNKNOWN) {} - delete [] copy; - delete [] words; + delete[] copy; + delete[] words; } if (n < 0) break; @@ -509,8 +509,8 @@ void PairAmoeba::read_keyfile(char *filename) "LAMMPS does not recognize AMOEBA keyfile keyword {}", keyword); - delete [] copy; - delete [] words; + delete[] copy; + delete[] words; } // close key file @@ -562,8 +562,8 @@ int PairAmoeba::read_section_name(FILE *fp, char *line) if (strspn(line," \t\n\r") == strlen(line)) continue; nwords = tokenize(line,words,copy); if (nwords <= 2) { - delete [] copy; - delete [] words; + delete[] copy; + delete[] words; continue; } break; @@ -580,8 +580,8 @@ int PairAmoeba::read_section_name(FILE *fp, char *line) } int n = strlen(line); - delete [] copy; - delete [] words; + delete[] copy; + delete[] words; // skip next 2 lines of section header @@ -627,13 +627,13 @@ int PairAmoeba::read_section_line(FILE *fp, char *line, if (strspn(line," \t\n\r") == strlen(line)) continue; nwords = tokenize(line,words,copy); if (strstr(words[0],"####")) { - delete [] words; - delete [] copy; + delete[] words; + delete[] copy; return 0; } if (strstr(words[0],"#") || strstr(words[0],"!!") || !isalpha(words[0][0])) { - delete [] words; - delete [] copy; + delete[] words; + delete[] copy; words = NULL; copy = NULL; continue; @@ -642,8 +642,8 @@ int PairAmoeba::read_section_line(FILE *fp, char *line, ptr = fgets(next,MAXLINE,fp); if (!ptr) { nextflag = 0; - delete [] words; - delete [] copy; + delete[] words; + delete[] copy; return strlen(line); } nwords_next = tokenize(next,words_next,copy_next); @@ -651,17 +651,17 @@ int PairAmoeba::read_section_line(FILE *fp, char *line, if (words_next[0][0] == '#') break; if (isalpha(words_next[0][0])) break; strcat(line,next); - delete [] words_next; - delete [] copy_next; + delete[] words_next; + delete[] copy_next; } nextflag = 1; break; } - delete [] copy; - delete [] words; - delete [] copy_next; - delete [] words_next; + delete[] copy; + delete[] words; + delete[] copy_next; + delete[] words_next; int n = strlen(line); return n; @@ -708,13 +708,13 @@ int PairAmoeba::count_words(const char *line) strcpy(copy,line); if (strtok(copy," \t\n\r\f") == NULL) { - delete [] copy; + delete[] copy; return 0; } n = 1; while (strtok(NULL," \t\n\r\f")) n++; - delete [] copy; + delete[] copy; return n; } @@ -722,8 +722,6 @@ int PairAmoeba::count_words(const char *line) void PairAmoeba::file_ffield(int nwords, char **words) { - double tmp; - if (strcmp(words[0],"forcefield") == 0) { int n = strlen(words[1]) + 1; forcefield = new char[n]; @@ -866,8 +864,7 @@ void PairAmoeba::file_ffield(int nwords, char **words) strcmp(words[0],"direct-14-scale") == 0) { double tmp = utils::numeric(FLERR,words[1],true,lmp); if (tmp != 1.0) - error->all(FLERR,"AMOEBA FF file direct-scale 1-2, 1-3, 1-4 values " - "should be 1.0"); + error->all(FLERR,"AMOEBA FF file direct-scale 1-2, 1-3, 1-4 values should be 1.0"); } else if (strcmp(words[0],"mutual-11-scale") == 0) { polar_uscale = utils::numeric(FLERR,words[1],true,lmp); @@ -876,14 +873,11 @@ void PairAmoeba::file_ffield(int nwords, char **words) strcmp(words[0],"mutual-14-scale") == 0) { double tmp = utils::numeric(FLERR,words[1],true,lmp); if (tmp != 1.0) - error->all(FLERR,"AMOEBA FF file mutual-scale 1-2, 1-3, 1-4 values " - "should be 1.0"); + error->all(FLERR,"AMOEBA FF file mutual-scale 1-2, 1-3, 1-4 values should be 1.0"); // error if LAMMPS does not recognize keyword - } else error->all(FLERR, - "LAMMPS does not recognize AMOEBA PRM file setting {}", - words[0]); + } else error->all(FLERR, "LAMMPS does not recognize AMOEBA PRM file setting {}", words[0]); } /* ---------------------------------------------------------------------- */ @@ -1184,7 +1178,7 @@ void PairAmoeba::file_dippolar(int nwords, char **words) { int nparams; if (amoeba) nparams = 4; - if (hippo) nparams = 3; + else nparams = 3; if (nwords < nparams) error->all(FLERR,"AMOEBA dipole polarizability line is invalid"); diff --git a/src/AMOEBA/amoeba_induce.cpp b/src/AMOEBA/amoeba_induce.cpp index 4e5ae7e769..c075858a0f 100644 --- a/src/AMOEBA/amoeba_induce.cpp +++ b/src/AMOEBA/amoeba_induce.cpp @@ -12,9 +12,7 @@ ------------------------------------------------------------------------- */ #include "pair_amoeba.h" -#include -#include -#include + #include "amoeba_convolution.h" #include "atom.h" #include "domain.h" @@ -27,6 +25,9 @@ #include "memory.h" #include "error.h" +#include +#include + using namespace LAMMPS_NS; using namespace MathConst; @@ -48,7 +49,7 @@ enum{GORDON1,GORDON2}; void PairAmoeba::induce() { bool done; - int i,j,m,ii,itype; + int i,j,m,itype; int iter,maxiter; double polmin; double eps,epsold; @@ -65,8 +66,6 @@ void PairAmoeba::induce() // owned atoms - double **x = atom->x; - double **f = atom->f; int nlocal = atom->nlocal; // zero out the induced dipoles at each site @@ -386,8 +385,7 @@ void PairAmoeba::induce() // NOTE: could make this an error if (iter >= maxiter || eps > epsold) - if (me == 0) - error->warning(FLERR,"AMOEBA induced dipoles did not converge"); + if (comm->me == 0) error->warning(FLERR,"AMOEBA induced dipoles did not converge"); } // update the lists of previous induced dipole values @@ -530,12 +528,8 @@ void PairAmoeba::ulspred() void PairAmoeba::ufield0c(double **field, double **fieldp) { - int i,j,ii; + int i,j; double term; - double ucell[3],ucellp[3]; - - int inum; - int *ilist; // zero field,fieldp for owned and ghost atoms @@ -577,7 +571,7 @@ void PairAmoeba::ufield0c(double **field, double **fieldp) void PairAmoeba::uscale0b(int mode, double **rsd, double **rsdp, double **zrsd, double **zrsdp) { - int i,j,k,m,itype,jtype,iclass,jclass,igroup,jgroup; + int i,j,itype,jtype,iclass,jclass,igroup,jgroup; int ii,jj; double xi,yi,zi; double xr,yr,zr; @@ -585,8 +579,6 @@ void PairAmoeba::uscale0b(int mode, double **rsd, double **rsdp, double pdi,pti; double polmin; double poli,polik; - double corei,corek; - double vali,valk; double alphai,alphak; double damp,expdamp; double pgamma; @@ -598,7 +590,6 @@ void PairAmoeba::uscale0b(int mode, double **rsd, double **rsdp, // owned atoms - double *pval = atom->dvector[index_pval]; double **x = atom->x; int nlocal = atom->nlocal; int nall = nlocal + atom->nghost; @@ -703,10 +694,8 @@ void PairAmoeba::uscale0b(int mode, double **rsd, double **rsdp, if (amoeba) { pdi = pdamp[itype]; pti = thole[itype]; - } else if (hippo) { - corei = pcore[iclass]; + } else { alphai = palpha[iclass]; - vali = pval[i]; } // evaluate all sites in induce neigh list, no cutoff @@ -746,10 +735,8 @@ void PairAmoeba::uscale0b(int mode, double **rsd, double **rsdp, scale5 *= 1.0 - expdamp*(1.0-damp); } } - } else if (hippo) { - corek = pcore[jclass]; + } else { alphak = palpha[jclass]; - valk = pval[j]; dampmut(r,alphai,alphak,dmpik); scale3 = factor_wscale * dmpik[2]; scale5 = factor_wscale * dmpik[4]; @@ -778,12 +765,9 @@ void PairAmoeba::uscale0b(int mode, double **rsd, double **rsdp, void PairAmoeba::dfield0c(double **field, double **fieldp) { - int i,j,ii; + int i,j; double term; - int inum; - int *ilist; - // zero out field,fieldp for owned and ghost atoms int nlocal = atom->nlocal; @@ -1149,7 +1133,7 @@ void PairAmoeba::udirect1(double **field) void PairAmoeba::udirect2b(double **field, double **fieldp) { - int i,j,k,m,n,ii,jj,kk,kkk,jextra,ndip,itype,jtype,iclass,jclass,igroup,jgroup; + int i,j,m,n,ii,jj,jextra,ndip,itype,jtype,iclass,jclass,igroup,jgroup; double xr,yr,zr,r,r2; double rr1,rr2,rr3; double rr5,rr7; @@ -1236,7 +1220,7 @@ void PairAmoeba::udirect2b(double **field, double **fieldp) pdi = pdamp[itype]; pti = thole[itype]; ddi = dirdamp[itype]; - } else if (hippo) { + } else { corei = pcore[iclass]; alphai = palpha[iclass]; vali = pval[i]; @@ -1269,7 +1253,7 @@ void PairAmoeba::udirect2b(double **field, double **fieldp) factor_dscale = factor_uscale = 1.0; } - } else if (hippo) { + } else { factor_wscale = special_polar_wscale[sbmask15(jextra)]; if (igroup == jgroup) { factor_dscale = factor_pscale = special_polar_piscale[sbmask15(jextra)]; @@ -1415,7 +1399,7 @@ void PairAmoeba::udirect2b(double **field, double **fieldp) // find the field components for charge penetration damping - } else if (hippo) { + } else { corek = pcore[jclass]; alphak = palpha[jclass]; valk = pval[j]; diff --git a/src/AMOEBA/amoeba_kspace.cpp b/src/AMOEBA/amoeba_kspace.cpp index 1bd5005f8a..6f76c7ec51 100644 --- a/src/AMOEBA/amoeba_kspace.cpp +++ b/src/AMOEBA/amoeba_kspace.cpp @@ -79,8 +79,8 @@ void PairAmoeba::moduli() // perform deallocation of local arrays - delete [] array; - delete [] bsarray; + delete[] array; + delete[] bsarray; } /* ---------------------------------------------------------------------- diff --git a/src/AMOEBA/amoeba_multipole.cpp b/src/AMOEBA/amoeba_multipole.cpp index 9532f3d7fd..790a6e6c05 100644 --- a/src/AMOEBA/amoeba_multipole.cpp +++ b/src/AMOEBA/amoeba_multipole.cpp @@ -228,7 +228,7 @@ void PairAmoeba::multipole_real() qiyy = rpole[i][8]; qiyz = rpole[i][9]; qizz = rpole[i][12]; - if (hippo) { + if (!amoeba) { corei = pcore[iclass]; alphai = palpha[iclass]; vali = pval[i]; @@ -363,7 +363,7 @@ void PairAmoeba::multipole_real() // find damped multipole intermediates and energy value - if (hippo) { + if (!amoeba) { corek = pcore[jclass]; alphak = palpha[jclass]; valk = pval[j]; diff --git a/src/AMOEBA/amoeba_polar.cpp b/src/AMOEBA/amoeba_polar.cpp index 75acd402f9..f052e9ebc6 100644 --- a/src/AMOEBA/amoeba_polar.cpp +++ b/src/AMOEBA/amoeba_polar.cpp @@ -12,9 +12,8 @@ ------------------------------------------------------------------------- */ #include "pair_amoeba.h" -#include -#include #include "amoeba_convolution.h" + #include "atom.h" #include "domain.h" #include "comm.h" @@ -23,6 +22,9 @@ #include "math_const.h" #include "memory.h" +#include +#include + using namespace LAMMPS_NS; using namespace MathConst; @@ -37,17 +39,11 @@ enum{VDWL,REPULSE,QFER,DISP,MPOLE,POLAR,USOLV,DISP_LONG,MPOLE_LONG,POLAR_LONG}; void PairAmoeba::polar() { - int i,j,ii; + int i; int ix,iy,iz; double felec,term; double dix,diy,diz; double uix,uiy,uiz; - double xd,yd,zd; - double xq,yq,zq; - double xu,yu,zu; - double xup,yup,zup; - double xv,yv,zv,vterm; - double xufield,yufield,zufield; double xix,yix,zix; double xiy,yiy,ziy; double xiz,yiz,ziz; @@ -143,16 +139,11 @@ void PairAmoeba::polar() void PairAmoeba::polar_energy() { - int i,j,ii,itype; - double e,felec,fi,term; - double xd,yd,zd; - double xu,yu,zu; - double dix,diy,diz; - double uix,uiy,uiz; + int i,j,itype; + double e,felec,fi; // owned atoms - double **x = atom->x; int nlocal = atom->nlocal; // set the energy unit conversion factor @@ -184,7 +175,7 @@ void PairAmoeba::polar_real() double alsq2,alsq2n; double exp2a,ralpha; double damp,expdamp; - double pdi,pti,ddi; + double pdi,pti; double pgamma; double temp3,temp5,temp7; double sc3,sc5,sc7; @@ -193,7 +184,7 @@ void PairAmoeba::polar_real() double usc3,usc5; double psr3,psr5,psr7; double dsr3,dsr5,dsr7; - double usr3,usr5; + double usr5; double rr3core,rr5core; double rr3i,rr5i; double rr7i,rr9i; @@ -222,7 +213,6 @@ void PairAmoeba::polar_real() double vali,valk; double alphai,alphak; double uirm,ukrm; - double uirt,ukrt; double tuir,tukr; double tixx,tiyy,tizz; double tixy,tixz,tiyz; @@ -343,8 +333,7 @@ void PairAmoeba::polar_real() if (amoeba) { pdi = pdamp[itype]; pti = thole[itype]; - ddi = dirdamp[itype]; - } else if (hippo) { + } else { corei = pcore[iclass]; alphai = palpha[iclass]; vali = pval[i]; @@ -377,7 +366,7 @@ void PairAmoeba::polar_real() factor_dscale = factor_uscale = 1.0; } - } else if (hippo) { + } else { factor_wscale = special_polar_wscale[sbmask15(jextra)]; if (igroup == jgroup) { factor_dscale = factor_pscale = special_polar_piscale[sbmask15(jextra)]; @@ -498,7 +487,6 @@ void PairAmoeba::polar_real() dsr3 = bn[1] - dsc3*rr3; dsr5 = bn[2] - dsc5*rr5; dsr7 = bn[3] - dsc7*rr7; - usr3 = bn[1] - usc3*rr3; usr5 = bn[2] - usc5*rr5; for (k = 0; k < 3; k++) { prc3[k] = rc3[k] * factor_pscale; @@ -514,7 +502,7 @@ void PairAmoeba::polar_real() // apply charge penetration damping to scale factors - } else if (hippo) { + } else { corek = pcore[jclass]; alphak = palpha[jclass]; valk = pval[j]; @@ -544,7 +532,7 @@ void PairAmoeba::polar_real() tkz3 = psr3*uiz + dsr3*uizp; tuir = -psr5*ukr - dsr5*ukrp; tukr = -psr5*uir - dsr5*uirp; - } else if (hippo) { + } else { tix3 = 2.0*rr3i*ukx; tiy3 = 2.0*rr3i*uky; tiz3 = 2.0*rr3i*ukz; @@ -574,7 +562,7 @@ void PairAmoeba::polar_real() tuir = -psr7*ukr - dsr7*ukrp; tukr = -psr7*uir - dsr7*uirp; - } else if (hippo) { + } else { tix5 = 4.0 * (rr5i*ukx); tiy5 = 4.0 * (rr5i*uky); tiz5 = 4.0 * (rr5i*ukz); @@ -728,7 +716,7 @@ void PairAmoeba::polar_real() // get the field gradient for direct polarization force - } else if (hippo) { + } else { term1i = rr3i - rr5i*xr*xr; term1core = rr3core - rr5core*xr*xr; term2i = 2.0*rr5i*xr ; @@ -895,7 +883,7 @@ void PairAmoeba::polar_real() // get the dtau/dr terms used for mutual polarization force - } else if (poltyp == MUTUAL && hippo) { + } else if (poltyp == MUTUAL && !amoeba) { term1 = 2.0 * rr5ik; term2 = term1*xr; term3 = rr5ik - rr7ik*xr*xr; @@ -979,7 +967,7 @@ void PairAmoeba::polar_real() // get the dtau/dr terms used for OPT polarization force - } else if (poltyp == OPT && hippo) { + } else if (poltyp == OPT && !amoeba) { for (k = 0; k < optorder; k++) { uirm = uopt[i][k][0]*xr + uopt[i][k][1]*yr + uopt[i][k][2]*zr; for (m = 0; m < optorder-k; m++) { @@ -1234,7 +1222,6 @@ void PairAmoeba::polar_kspace() int nhalf1,nhalf2,nhalf3; int nxlo,nxhi,nylo,nyhi,nzlo,nzhi; int j1,j2,j3; - int k1,k2,k3; int ix,iy,iz; double eterm,felec; double r1,r2,r3; diff --git a/src/AMOEBA/amoeba_repulsion.cpp b/src/AMOEBA/amoeba_repulsion.cpp index 632996c264..1cad7caa44 100644 --- a/src/AMOEBA/amoeba_repulsion.cpp +++ b/src/AMOEBA/amoeba_repulsion.cpp @@ -42,10 +42,10 @@ void PairAmoeba::repulsion() double r,r2,r3,r4,r5; double rr1,rr3,rr5; double rr7,rr9,rr11; - double ci,dix,diy,diz; + double dix,diy,diz; double qixx,qixy,qixz; double qiyy,qiyz,qizz; - double ck,dkx,dky,dkz; + double dkx,dky,dkz; double qkxx,qkxy,qkxz; double qkyy,qkyz,qkzz; double dir,dkr,dik,qik; @@ -128,7 +128,6 @@ void PairAmoeba::repulsion() sizi = sizpr[itype]; dmpi = dmppr[itype]; vali = elepr[itype]; - ci = rpole[i][0]; dix = rpole[i][1]; diy = rpole[i][2]; diz = rpole[i][3]; @@ -157,7 +156,6 @@ void PairAmoeba::repulsion() sizk = sizpr[jtype]; dmpk = dmppr[jtype]; valk = elepr[jtype]; - ck = rpole[j][0]; dkx = rpole[j][1]; dky = rpole[j][2]; dkz = rpole[j][3]; @@ -480,7 +478,7 @@ void PairAmoeba::damprep(double r, double r2, double rr1, double rr3, r8 = r7 * r; dmpi27 = dmpi2 * dmpi26; d5s = (dmpi25*r6 + dmpi26*r7 + dmpi27*r8/3.0) * expi / 945.0; - } + } else d5s = 0.0; // treat the case where alpha damping exponents are unequal @@ -548,7 +546,7 @@ void PairAmoeba::damprep(double r, double r2, double rr1, double rr3, (4.0/945.0)*dmpi26*dmpk2*r5/term + (4.0/63.0)*dmpi25*dmpk2*r4/term + (4.0/9.0)*dmpi24*dmpk2*r3/term + (16.0/9.0)*dmpi23*dmpk2*r2/term + 4.0*dmpi22*dmpk2*r/term + 4.0*dmpi2*dmpk2/term) * expi; - } + } else d5s = 0.0; } // convert partial derivatives into full derivatives diff --git a/src/AMOEBA/amoeba_utils.cpp b/src/AMOEBA/amoeba_utils.cpp index b02ef7ca44..767ceac32b 100644 --- a/src/AMOEBA/amoeba_utils.cpp +++ b/src/AMOEBA/amoeba_utils.cpp @@ -287,7 +287,7 @@ void PairAmoeba::kmpole() void PairAmoeba::chkpole(int i) { bool check; - int ia,ib,ic,id; + int ib,ic,id; double xad,yad,zad; double xbd,ybd,zbd; double xcd,ycd,zcd; @@ -350,7 +350,6 @@ void PairAmoeba::chkpole(int i) void PairAmoeba::rotmat(int i) { - int ii; int ix,iy,iz; double r,dot; double xi,yi,zi; @@ -664,7 +663,6 @@ void PairAmoeba::add_onefive_neighbors() } if (which) jlist[jj] = j ^ (which << SBBITS15); - int newwhich = sbmask15(jlist[jj]); } } } @@ -690,7 +688,6 @@ void PairAmoeba::find_hydrogen_neighbors() int nlocal = atom->nlocal; int nall = nlocal + atom->nghost; - int nmissing = 0; for (int i = 0; i < nall; i++) { if (redID[i] == 0.0) red2local[i] = i; @@ -711,7 +708,7 @@ void PairAmoeba::find_hydrogen_neighbors() void PairAmoeba::find_multipole_neighbors() { - int index,ypos; + int index; tagint xaxisID,yaxisID,zaxisID; // grab current pts for xaxis,yaxis,zaxis @@ -811,13 +808,13 @@ void PairAmoeba::torque2force(int i, double *trq, double ursiz,ussiz; double vssiz,wssiz; double delsiz,dphiddel; - double uvcos,uwcos,urcos; - double vwcos,vscos,wscos; + double uvcos,urcos; + double vscos,wscos; double upcos,vpcos,wpcos; double rwcos,rucos,rvcos; double ut1cos,ut2cos; - double uvsin,uwsin,ursin; - double vwsin,vssin,wssin; + double uvsin,ursin; + double vssin,wssin; double rwsin,rusin,rvsin; double ut1sin,ut2sin; double dphidu,dphidv,dphidw; @@ -959,10 +956,6 @@ void PairAmoeba::torque2force(int i, double *trq, uvcos = u[0]*v[0] + u[1]*v[1] + u[2]*v[2]; uvsin = sqrt(1.0 - uvcos*uvcos); - uwcos = u[0]*w[0] + u[1]*w[1] + u[2]*w[2]; - uwsin = sqrt(1.0 - uwcos*uwcos); - vwcos = v[0]*w[0] + v[1]*w[1] + v[2]*w[2]; - vwsin = sqrt(1.0 - vwcos*vwcos); if (axetyp == ZBISECT) { urcos = u[0]*r[0] + u[1]*r[1] + u[2]*r[2]; ursin = sqrt(1.0 - urcos*urcos); diff --git a/src/AMOEBA/angle_amoeba.cpp b/src/AMOEBA/angle_amoeba.cpp index 7f9b808766..ca32d37fe3 100644 --- a/src/AMOEBA/angle_amoeba.cpp +++ b/src/AMOEBA/angle_amoeba.cpp @@ -91,12 +91,6 @@ AngleAmoeba::~AngleAmoeba() void AngleAmoeba::compute(int eflag, int vflag) { int i1,i2,i3,n,type,tflag,uflag; - double delx1,dely1,delz1,delx2,dely2,delz2; - double f1[3],f3[3]; - double dtheta,dtheta2,dtheta3,dtheta4,dtheta5,dtheta6,de_angle; - double dr1,dr2,tk1,tk2,aa1,aa2,aa11,aa12,aa21,aa22; - double rsq1,rsq2,r1,r2,c,s,a,a11,a12,a22,b1,b2; - double vx11,vx12,vy11,vy12,vz11,vz12,vx21,vx22,vy21,vy22,vz21,vz22; int **anglelist = neighbor->anglelist; int **nspecial = atom->nspecial; @@ -143,9 +137,8 @@ void AngleAmoeba::tinker_angle(int i1, int i2, int i3, int type, int eflag) double delx1,dely1,delz1,delx2,dely2,delz2; double eangle,f1[3],f3[3]; double dtheta,dtheta2,dtheta3,dtheta4,dtheta5,dtheta6,de_angle; - double dr1,dr2,tk1,tk2,aa1,aa2,aa11,aa12,aa21,aa22; - double rsq1,rsq2,r1,r2,c,s,a,a11,a12,a22,b1,b2; - double vx11,vx12,vy11,vy12,vz11,vz12,vx21,vx22,vy21,vy22,vz21,vz22; + double rsq1,rsq2,r1,r2,c,s,a; + double a11,a12,a22; double **x = atom->x; double **f = atom->f; @@ -248,8 +241,7 @@ void AngleAmoeba::tinker_anglep(int i1, int i2, int i3, int type, int eflag) double rap2,rcp2; double dtheta,dtheta2,dtheta3,dtheta4,dtheta5,dtheta6; double xm,ym,zm,rm,dot; - double cosine,angle; - double eangle,deddt; + double cosine,eangle,deddt; double dedxip,dedyip,dedzip,dpdxia,dpdyia,dpdzia,dpdxic,dpdyic,dpdzic; double delta,delta2,ptrt2,term,terma,termc; double f1[3],f2[3],f3[3],f4[3]; diff --git a/src/AMOEBA/fix_amoeba_bitorsion.cpp b/src/AMOEBA/fix_amoeba_bitorsion.cpp index 17d35a8ffb..53f36353f0 100644 --- a/src/AMOEBA/fix_amoeba_bitorsion.cpp +++ b/src/AMOEBA/fix_amoeba_bitorsion.cpp @@ -61,10 +61,9 @@ static constexpr double WT[16][16] = { /* ---------------------------------------------------------------------- */ FixAmoebaBiTorsion::FixAmoebaBiTorsion(LAMMPS *lmp, int narg, char **arg) : - Fix(lmp, narg, arg), - bitorsion_list(nullptr), num_bitorsion(nullptr), bitorsion_type(nullptr), - bitorsion_atom1(nullptr), bitorsion_atom2(nullptr), bitorsion_atom3(nullptr), - bitorsion_atom4(nullptr), bitorsion_atom5(nullptr) + Fix(lmp, narg, arg), num_bitorsion(nullptr), bitorsion_type(nullptr), bitorsion_atom1(nullptr), + bitorsion_atom2(nullptr), bitorsion_atom3(nullptr), bitorsion_atom4(nullptr), + bitorsion_atom5(nullptr), bitorsion_list(nullptr) { if (narg != 4) error->all(FLERR,"Illegal fix amoeba/bitorsion command"); @@ -145,8 +144,8 @@ FixAmoebaBiTorsion::~FixAmoebaBiTorsion() // BiTorsion grid data - delete [] nxgrid; - delete [] nygrid; + delete[] nxgrid; + delete[] nygrid; for (int itype = 1; itype <= nbitypes; itype++) { memory->destroy(ttx[itype]); memory->destroy(tty[itype]); @@ -155,12 +154,12 @@ FixAmoebaBiTorsion::~FixAmoebaBiTorsion() memory->destroy(tby[itype]); memory->destroy(tbxy[itype]); } - delete [] ttx; - delete [] tty; - delete [] tbf; - delete [] tbx; - delete [] tby; - delete [] tbxy; + delete[] ttx; + delete[] tty; + delete[] tbf; + delete[] tbx; + delete[] tby; + delete[] tbxy; } /* ---------------------------------------------------------------------- */ @@ -326,7 +325,7 @@ void FixAmoebaBiTorsion::post_force(int vflag) int nx,ny,nlo,nhi,nt; int xlo,ylo; int pos1,pos2; - double e,fgrp,sign,dot; + double e,sign,dot; double angle1,angle2; double value1,value2; double cosine1,cosine2; @@ -808,7 +807,7 @@ void FixAmoebaBiTorsion::read_grid_data(char *bitorsion_file) void FixAmoebaBiTorsion::create_splines() { - int i,j,nx,ny; + int nx,ny; // allocate work vectors for cspline() and nspline() methods // all are 0-indexed here and in Tinker @@ -1149,7 +1148,7 @@ void FixAmoebaBiTorsion::cytsyp(int n, double *dm, double *du, if (dm[i] < 0.0) { iflag = -1; return; - } else if (abs(dm[i])*d <= eps) { + } else if (fabs(dm[i])*d <= eps) { iflag = 0; return; } diff --git a/src/AMOEBA/fix_amoeba_pitorsion.cpp b/src/AMOEBA/fix_amoeba_pitorsion.cpp index 68a3d02ea2..967972fad7 100644 --- a/src/AMOEBA/fix_amoeba_pitorsion.cpp +++ b/src/AMOEBA/fix_amoeba_pitorsion.cpp @@ -39,10 +39,9 @@ using namespace MathConst; /* ---------------------------------------------------------------------- */ FixAmoebaPiTorsion::FixAmoebaPiTorsion(LAMMPS *lmp, int narg, char **arg) : - Fix(lmp, narg, arg), - pitorsion_list(nullptr), num_pitorsion(nullptr), pitorsion_type(nullptr), - pitorsion_atom1(nullptr), pitorsion_atom2(nullptr), pitorsion_atom3(nullptr), - pitorsion_atom4(nullptr), pitorsion_atom5(nullptr), pitorsion_atom6(nullptr) + Fix(lmp, narg, arg), num_pitorsion(nullptr), pitorsion_type(nullptr), pitorsion_atom1(nullptr), + pitorsion_atom2(nullptr), pitorsion_atom3(nullptr), pitorsion_atom4(nullptr), pitorsion_atom5(nullptr), + pitorsion_atom6(nullptr), pitorsion_list(nullptr) { if (narg != 3) error->all(FLERR,"Illegal fix amoeba/pitorsion command"); @@ -330,8 +329,6 @@ void FixAmoebaPiTorsion::post_force(int vflag) double dedxip,dedyip,dedzip; double dedxiq,dedyiq,dedziq; double vxterm,vyterm,vzterm; - double vxx,vyy,vzz; - double vyx,vzx,vzy; int nlist,list[6]; double v[6]; @@ -611,10 +608,9 @@ void FixAmoebaPiTorsion::read_data_header(char *line) id_offset is applied to atomID fields if multiple data files are read ------------------------------------------------------------------------- */ -void FixAmoebaPiTorsion::read_data_section(char *keyword, int n, char *buf, - tagint id_offset) +void FixAmoebaPiTorsion::read_data_section(char *keyword, int n, char *buf, tagint id_offset) { - int which; + int which = -1; if (strstr(keyword,"PiTorsions")) { sscanf(keyword,BIGINT_FORMAT,&npitorsions); @@ -777,9 +773,9 @@ bigint FixAmoebaPiTorsion::read_data_skip_lines(char *keyword) void FixAmoebaPiTorsion::write_data_header(FILE *fp, int mth) { - if (mth == 0) fprintf(fp,BIGINT_FORMAT " pitorsions\n",npitorsions); + if (mth == 0) fmt::print(fp,"{} pitorsions\n",npitorsions); else if (mth == 1) - fprintf(fp,BIGINT_FORMAT " pitorsion types\n",npitorsion_types); + fmt::print(fp, "{} pitorsion types\n",npitorsion_types); } /* ---------------------------------------------------------------------- diff --git a/src/AMOEBA/pair_amoeba.cpp b/src/AMOEBA/pair_amoeba.cpp index 1a400c84ce..d4aa4d6d80 100644 --- a/src/AMOEBA/pair_amoeba.cpp +++ b/src/AMOEBA/pair_amoeba.cpp @@ -53,25 +53,8 @@ enum{GEAR,ASPC,LSQR}; PairAmoeba::PairAmoeba(LAMMPS *lmp) : Pair(lmp) { - // error checks - - if (strcmp(update->unit_style,"real") != 0) - error->all(FLERR,"Pair style amoeba/hippo require real units"); - if (force->newton_pair == 0) - error->all(FLERR,"Pair style amoeba/hippo require newton pair on"); - if (domain->dimension == 2) - error->all(FLERR,"Pair style amoeba/hippo requires 3d system"); - if (domain->triclinic) - error->all(FLERR,"Pair style amoeba/hippo does not yet support " - "triclinic systems"); - - int nperiodic = domain->xperiodic + domain->yperiodic + domain->zperiodic; - if (nperiodic != 0 && nperiodic != 3) - error->all(FLERR,"Pair style amoeba/hippo requires " - "fully periodic or fully non-periodic system"); - - me = comm->me; - nprocs = comm->nprocs; + amoeba = true; + mystyle = "amoeba"; // pair style settings @@ -84,9 +67,6 @@ PairAmoeba::PairAmoeba(LAMMPS *lmp) : Pair(lmp) // force field settings - amoeba = 1; - hippo = 0; - nmax = 0; xaxis2local = yaxis2local = zaxis2local = NULL; rpole = NULL; @@ -173,7 +153,7 @@ PairAmoeba::PairAmoeba(LAMMPS *lmp) : Pair(lmp) PairAmoeba::~PairAmoeba() { - delete [] pvector; + delete[] pvector; // check nfix in case all fixes have already been deleted @@ -294,8 +274,7 @@ void PairAmoeba::compute(int eflag, int vflag) ev_init(eflag,vflag); if (eflag_atom || vflag_atom) - error->all(FLERR,"Cannot (yet) compute per-atom energy/virial " - "with pair_style amoeba/hippo"); + error->all(FLERR,"Cannot (yet) compute per-atom energy/virial with pair_style {}", mystyle); // zero energy/virial components @@ -337,7 +316,7 @@ void PairAmoeba::compute(int eflag, int vflag) comm->forward_comm(this); kmpole(); - if (hippo) { + if (!amoeba) { double *pval = atom->dvector[index_pval]; double **pole = fixpole->astore; int nlocal = atom->nlocal; @@ -438,12 +417,12 @@ void PairAmoeba::compute(int eflag, int vflag) // Pauli repulsion, pairwise - if (hippo && repulse_flag) repulsion(); + if (!amoeba && repulse_flag) repulsion(); time3 = MPI_Wtime(); // Ewald dispersion, pairwise and long range - if (hippo && (disp_rspace_flag || disp_kspace_flag)) dispersion(); + if (!amoeba && (disp_rspace_flag || disp_kspace_flag)) dispersion(); time4 = MPI_Wtime(); // multipole, pairwise and long range @@ -468,7 +447,7 @@ void PairAmoeba::compute(int eflag, int vflag) // charge transfer, pairwise - if (hippo && qxfer_flag) charge_transfer(); + if (!amoeba && qxfer_flag) charge_transfer(); time8 = MPI_Wtime(); // store energy components for output by compute pair command @@ -509,34 +488,34 @@ void PairAmoeba::finish() { double ave; MPI_Allreduce(&time_init,&ave,1,MPI_DOUBLE,MPI_SUM,world); - time_init = ave/nprocs; + time_init = ave/comm->nprocs; MPI_Allreduce(&time_hal,&ave,1,MPI_DOUBLE,MPI_SUM,world); - time_hal = ave/nprocs; + time_hal = ave/comm->nprocs; MPI_Allreduce(&time_repulse,&ave,1,MPI_DOUBLE,MPI_SUM,world); - time_repulse = ave/nprocs; + time_repulse = ave/comm->nprocs; MPI_Allreduce(&time_disp,&ave,1,MPI_DOUBLE,MPI_SUM,world); - time_disp = ave/nprocs; + time_disp = ave/comm->nprocs; MPI_Allreduce(&time_mpole,&ave,1,MPI_DOUBLE,MPI_SUM,world); - time_mpole = ave/nprocs; + time_mpole = ave/comm->nprocs; MPI_Allreduce(&time_induce,&ave,1,MPI_DOUBLE,MPI_SUM,world); - time_induce = ave/nprocs; + time_induce = ave/comm->nprocs; MPI_Allreduce(&time_polar,&ave,1,MPI_DOUBLE,MPI_SUM,world); - time_polar = ave/nprocs; + time_polar = ave/comm->nprocs; MPI_Allreduce(&time_qxfer,&ave,1,MPI_DOUBLE,MPI_SUM,world); - time_qxfer = ave/nprocs; + time_qxfer = ave/comm->nprocs; double time_total = (time_init + time_hal + time_repulse + time_disp + time_mpole + time_induce + time_polar + time_qxfer) / 100.0; - if (me == 0) { - utils::logmesg(lmp,"\nAMEOBA/HIPPO timing breakdown:\n"); + if (comm->me == 0) { + utils::logmesg(lmp,"\n{} timing breakdown:\n", utils::uppercase(mystyle)); utils::logmesg(lmp," Init time: {:.6g} {:.3g}%\n", time_init, time_init/time_total); if (amoeba) { utils::logmesg(lmp," Hal time: {:.6g} {:.3g}%\n", time_hal, time_hal/time_total); @@ -547,7 +526,7 @@ void PairAmoeba::finish() utils::logmesg(lmp," Mpole time: {:.6g} {:.3g}%\n", time_mpole, time_mpole/time_total); utils::logmesg(lmp," Induce time: {:.6g} {:.3g}%\n", time_induce, time_induce/time_total); utils::logmesg(lmp," Polar time: {:.6g} {:.3g}%\n", time_polar, time_polar/time_total); - if (hippo) + if (!amoeba) utils::logmesg(lmp," Qxfer time: {:.6g} {:.6g}\n", time_qxfer, time_qxfer/time_total); utils::logmesg(lmp," Total time: {:.6g}\n",time_total * 100.0); } @@ -648,15 +627,9 @@ void PairAmoeba::coeff(int narg, char **arg) if (!allocated) allocate(); - if (narg < 3 && narg > 4) - error->all(FLERR,"Incorrect args for pair coefficients"); + if ((narg < 3) || (narg > 4)) error->all(FLERR,"Incorrect args for pair coefficients"); - // insure I,J args are * * - - if (strcmp(arg[0],"*") != 0 || strcmp(arg[1],"*") != 0) - error->all(FLERR,"Incorrect args for pair coefficients"); - - // set setflag since coeff() called once with I,J = * * + // set setflag since coeff() is only called once with I,J = * * int n = atom->ntypes; for (i = 1; i <= n; i++) @@ -733,17 +706,29 @@ void PairAmoeba::coeff(int narg, char **arg) void PairAmoeba::init_style() { // error checks + if (strcmp(update->unit_style,"real") != 0) + error->all(FLERR, "Pair style {} requires real units", mystyle); + if (force->newton_pair == 0) + error->all(FLERR, "Pair style {} requires newton pair on", mystyle); + if (domain->dimension == 2) + error->all(FLERR, "Pair style {} requires a 3d system", mystyle); + if (domain->triclinic) + error->all(FLERR, "Pair style {} does not (yet) support triclinic systems", mystyle); + + int nperiodic = domain->xperiodic + domain->yperiodic + domain->zperiodic; + if ((nperiodic != 0) && (nperiodic != 3)) + error->all(FLERR,"Pair style {} requires a fully periodic or fully non-periodic system", + mystyle); if (!atom->q_flag) - error->all(FLERR,"Pair style {} requires atom attribute q", (amoeba) ? "amoeba" : "hippo"); + error->all(FLERR,"Pair style {} requires atom attribute q", mystyle); //if (!force->special_onefive) // error->all(FLERR,"Pair style amoeba/hippo requires special_bonds one/five be set"); // b/c polar uses mutipole virial terms if (apewald == aeewald && polar_kspace_flag && !mpole_kspace_flag) - error->all(FLERR, - "Pair amoeba with apewald = aeewald requires mpole and polar together"); + error->all(FLERR, "Pair {} with apewald = aeewald requires mpole and polar together", mystyle); // check if all custom atom arrays were set via fix property/atom @@ -751,24 +736,24 @@ void PairAmoeba::init_style() index_amtype = atom->find_custom("amtype",flag,cols); if (index_amtype < 0 || flag || cols) - error->all(FLERR,"Pair amoeba amtype is not defined"); + error->all(FLERR,"Pair {} amtype is not defined", mystyle); index_amgroup = atom->find_custom("amgroup",flag,cols); if (index_amgroup < 0 || flag || cols) - error->all(FLERR,"Pair amoeba amgroup is not defined"); + error->all(FLERR,"Pair {} amgroup is not defined", mystyle); index_redID = atom->find_custom("redID",flag,cols); if (index_redID < 0 || !flag || cols) - error->all(FLERR,"Pair amoeba redID is not defined"); + error->all(FLERR,"Pair {} redID is not defined", mystyle); index_xyzaxis = atom->find_custom("xyzaxis",flag,cols); if (index_xyzaxis < 0 || !flag || cols == 0) - error->all(FLERR,"Pair amoeba xyzaxis is not defined"); + error->all(FLERR,"Pair {} xyzaxis is not defined", mystyle); index_polaxe = atom->find_custom("polaxe",flag,cols); if (index_polaxe < 0 || flag || cols) - error->all(FLERR,"Pair amoeba polaxe is not defined"); + error->all(FLERR,"Pair {} polaxe is not defined", mystyle); index_pval = atom->find_custom("pval",flag,cols); if (index_pval < 0 || !flag || cols) - error->all(FLERR,"Pair amoeba pval is not defined"); + error->all(FLERR,"Pair {} pval is not defined", mystyle); // ------------------------------------------------------------------- // one-time initializations @@ -888,8 +873,8 @@ void PairAmoeba::init_style() for (int i = 1; i <= n_amclass; i++) csixpr += csix[i]*csix[i] * csix_num[i]*csix_num[i]; - delete [] csix_num_one; - delete [] csix_num; + delete[] csix_num_one; + delete[] csix_num; } // initialize peratom pval to zero @@ -969,8 +954,8 @@ void PairAmoeba::init_style() // can now set comm size needed by this Pair // cfstyle KMPOLE is max # of 1-2 bond partners, smaller than comm_forward - if (amoeba) comm_forward = 16; // xred, rpole - else if (hippo) comm_forward = 13; // just rpole + if (amoeba) comm_forward = 16; // xred, rpole + else comm_forward = 13; // just rpole int fsize = 6; if (poltyp == OPT) fsize += 6*optorder; //if (poltyp == TCG) fsize += 12*tcgnab; @@ -980,7 +965,7 @@ void PairAmoeba::init_style() // request standard neighbor list - int irequest = neighbor->request(this,instance_me); + neighbor->add_request(this); } /* ---------------------------------------------------------------------- @@ -989,50 +974,43 @@ void PairAmoeba::init_style() void PairAmoeba::print_settings() { - std::string mesg = "AMOEBA/HIPPO force field settings\n"; + std::string mesg = utils::uppercase(mystyle) + " force field settings\n"; if (amoeba) { choose(HAL); - mesg += fmt::format(" hal: cut {} taper {} vscale {} {} {} {}\n", - sqrt(off2),sqrt(cut2), + mesg += fmt::format(" hal: cut {} taper {} vscale {} {} {} {}\n", sqrt(off2),sqrt(cut2), special_hal[1],special_hal[2],special_hal[3],special_hal[4]); - } - - if (hippo) { + } else { choose(REPULSE); - mesg += fmt::format(" repulsion: cut {} taper {} rscale {} {} {} {}\n", - sqrt(off2),sqrt(cut2), + mesg += fmt::format(" repulsion: cut {} taper {} rscale {} {} {} {}\n", sqrt(off2),sqrt(cut2), special_repel[1],special_repel[2],special_repel[3],special_repel[4]); choose(QFER); - mesg += fmt::format(" qxfer: cut {} taper {} mscale {} {} {} {}\n", - sqrt(off2),sqrt(cut2), + mesg += fmt::format(" qxfer: cut {} taper {} mscale {} {} {} {}\n", sqrt(off2),sqrt(cut2), special_mpole[1],special_mpole[2],special_mpole[3],special_mpole[4]); if (use_dewald) { choose(DISP_LONG); - mesg += fmt::format(" dispersion: cut {} aewald {} bsorder {} " - "FFT {} {} {} dspscale {} {} {} {}\n", - sqrt(off2),aewald,bsdorder,ndfft1,ndfft2,ndfft3, + mesg += fmt::format(" dispersion: cut {} aewald {} bsorder {} FFT {} {} {} " + "dspscale {} {} {} {}\n", sqrt(off2),aewald,bsdorder,ndfft1,ndfft2,ndfft3, special_disp[1],special_disp[2],special_disp[3],special_disp[4]); } else { choose(DISP); mesg += fmt::format(" dispersion: cut {} aewald {} dspscale {} {} {} {}\n", - sqrt(off2),aewald, - special_disp[1],special_disp[2],special_disp[3],special_disp[4]); + sqrt(off2),aewald,special_disp[1], + special_disp[2],special_disp[3],special_disp[4]); } } if (use_ewald) { choose(MPOLE_LONG); - mesg += fmt::format(" multipole: cut {} aewald {} bsorder {} " - "FFT {} {} {} mscale {} {} {} {}\n", + mesg += fmt::format(" multipole: cut {} aewald {} bsorder {} FFT {} {} {} " + "mscale {} {} {} {}\n", sqrt(off2),aewald,bseorder,nefft1,nefft2,nefft3, special_mpole[1],special_mpole[2],special_mpole[3],special_mpole[4]); } else { choose(MPOLE); - mesg += fmt::format(" multipole: cut {} aewald {} mscale {} {} {} {}\n", - sqrt(off2),aewald, + mesg += fmt::format(" multipole: cut {} aewald {} mscale {} {} {} {}\n", sqrt(off2),aewald, special_mpole[1],special_mpole[2],special_mpole[3],special_mpole[4]); } @@ -1072,21 +1050,16 @@ void PairAmoeba::print_settings() init for one type pair i,j and corresponding j,i ------------------------------------------------------------------------- */ -double PairAmoeba::init_one(int i, int j) +double PairAmoeba::init_one(int /*i*/, int /*j*/) { double cutoff = 0.0; if (amoeba) { choose(HAL); cutoff = MAX(cutoff,sqrt(off2)); - } - - if (hippo) { + } else { choose(REPULSE); cutoff = MAX(cutoff,sqrt(off2)); - } - - if (hippo) { if (use_dewald) choose(DISP_LONG); else choose(DISP); cutoff = MAX(cutoff,sqrt(off2)); @@ -1100,7 +1073,7 @@ double PairAmoeba::init_one(int i, int j) else choose(POLAR); cutoff = MAX(cutoff,sqrt(off2)); - if (hippo) { + if (!amoeba) { choose(QFER); cutoff = MAX(cutoff,sqrt(off2)); } @@ -1607,7 +1580,6 @@ void PairAmoeba::assign_groups() int **nspecial = atom->nspecial; tagint *tag = atom->tag; int nlocal = atom->nlocal; - int nall = nlocal + atom->nghost; // initially, groupID = atomID // communicate new groupIDs to ghost atoms @@ -1711,7 +1683,8 @@ void PairAmoeba::assign_groups() bigint allbcount; MPI_Allreduce(&bcount,&allbcount,1,MPI_LMP_BIGINT,MPI_SUM,world); - if (comm->me == 0) utils::logmesg(lmp, " AMOEBA/HIPPO group count: {}\n",allbcount); + if (comm->me == 0) + utils::logmesg(lmp, " {} group count: {}\n",utils::uppercase(mystyle), allbcount); } /* ---------------------------------------------------------------------- @@ -1897,20 +1870,20 @@ void PairAmoeba::allocate_smallsize() void PairAmoeba::deallocate_smallsize() { - delete [] copt; - delete [] copm; - delete [] a_ualt; - delete [] ap_ualt; - delete [] b_ualt; - delete [] bp_ualt; + delete[] copt; + delete[] copm; + delete[] a_ualt; + delete[] ap_ualt; + delete[] b_ualt; + delete[] bp_ualt; memory->destroy(c_ualt); memory->destroy(cp_ualt); - delete [] bpred; - delete [] bpredp; - delete [] bpreds; - delete [] bpredps; - delete [] gear; - delete [] aspc; + delete[] bpred; + delete[] bpredp; + delete[] bpreds; + delete[] bpredps; + delete[] gear; + delete[] aspc; } /* ---------------------------------------------------------------------- @@ -1919,7 +1892,8 @@ void PairAmoeba::deallocate_smallsize() void PairAmoeba::choose(int which) { - double off,cut; + double off = 0.0; + double cut = 0.0; // short-range only terms diff --git a/src/AMOEBA/pair_amoeba.h b/src/AMOEBA/pair_amoeba.h index 52ef3490e6..d8c3555c50 100644 --- a/src/AMOEBA/pair_amoeba.h +++ b/src/AMOEBA/pair_amoeba.h @@ -62,15 +62,15 @@ class PairAmoeba : public Pair { double memory_usage(); protected: - int me,nprocs; - int nmax; // allocation for owned+ghost - int nlocalmax; // allocation for just owned - int cfstyle,crstyle; // style of forward/reverse comm operations + int nmax; // allocation for owned+ghost + int nlocalmax; // allocation for just owned + int cfstyle,crstyle; // style of forward/reverse comm operations int nualt; double electric; - double rotate[3][3]; // rotation matrix + double rotate[3][3]; // rotation matrix - int amoeba,hippo; // which force field, only one is set + bool amoeba; // which force field: amoeba == true, hippo == false + std::string mystyle; // text label for style int first_flag; // 1 before first init_style() int first_flag_compute; // 1 before first call to compute() int optlevel; diff --git a/src/AMOEBA/pair_hippo.cpp b/src/AMOEBA/pair_hippo.cpp index f64d419183..d798ce2d4b 100644 --- a/src/AMOEBA/pair_hippo.cpp +++ b/src/AMOEBA/pair_hippo.cpp @@ -19,6 +19,6 @@ using namespace LAMMPS_NS; PairHippo::PairHippo(LAMMPS *lmp) : PairAmoeba(lmp) { - amoeba = 0; - hippo = 1; + amoeba = false; + mystyle = "hippo"; } From e8dfb2fc38c9a40cdb1cbce011e1d8f0d242d252 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sat, 28 May 2022 09:23:08 -0400 Subject: [PATCH 239/585] fix off-by-one bug --- src/AMOEBA/pair_amoeba.cpp | 10 +++++----- 1 file changed, 5 insertions(+), 5 deletions(-) diff --git a/src/AMOEBA/pair_amoeba.cpp b/src/AMOEBA/pair_amoeba.cpp index d4aa4d6d80..5c12dc419c 100644 --- a/src/AMOEBA/pair_amoeba.cpp +++ b/src/AMOEBA/pair_amoeba.cpp @@ -453,11 +453,11 @@ void PairAmoeba::compute(int eflag, int vflag) // store energy components for output by compute pair command pvector[0] = ehal; - pvector[2] = erepulse; - pvector[3] = edisp; - pvector[4] = empole; - pvector[5] = epolar; - pvector[6] = eqxfer; + pvector[1] = erepulse; + pvector[2] = edisp; + pvector[3] = empole; + pvector[4] = epolar; + pvector[5] = eqxfer; // energy & virial summations From 9f7f043e832488c4223e938e2321c2a519f74c14 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sat, 28 May 2022 11:23:45 -0400 Subject: [PATCH 240/585] whitespace --- doc/src/pair_amoeba.rst | 6 +++--- src/AMOEBA/amoeba_file.cpp | 4 ++-- src/AMOEBA/amoeba_multipole.cpp | 6 +++--- src/AMOEBA/amoeba_polar.cpp | 4 ++-- src/AMOEBA/amoeba_utils.cpp | 2 +- src/AMOEBA/pair_amoeba.cpp | 6 +++--- src/AMOEBA/pair_amoeba.h | 2 +- 7 files changed, 15 insertions(+), 15 deletions(-) diff --git a/doc/src/pair_amoeba.rst b/doc/src/pair_amoeba.rst index 1436efa267..726917624f 100644 --- a/doc/src/pair_amoeba.rst +++ b/doc/src/pair_amoeba.rst @@ -68,7 +68,7 @@ while the HIPPO force field contains these terms: .. math:: - U_{hippo} = U_{multipole} + U_{polar} + U_{qxfer} + U_{repulsion} + U_{dispersion} + U_{hippo} = U_{multipole} + U_{polar} + U_{qxfer} + U_{repulsion} + U_{dispersion} Conceptually, these terms compute the following interactions: @@ -85,7 +85,7 @@ this doc page give full details for both force fields. The formulas for the AMOEBA energy terms are: -.. math:: +.. math:: U_{hal} = \epsilon_{ij} \left( \frac{1.07}{\rho_{ij} + 0.07} \right)^7 \left( \frac{1.12}{\rho_{ij}^7 + 0.12} - 2 \right) U_{multipole} = \vec{M_i}\bold{T_{ij}}\vec{M_j} @@ -94,7 +94,7 @@ The formulas for the AMOEBA energy terms are: The formulas for the HIPPO energy terms are: -.. math:: +.. math:: U_{multipole} = Z_i \frac{1}{r_{ij}} Z_j + Z_i T_{ij}^{damp} \vec{M_j} + Z_j T_{ji}^{damp} \vec{M_i} + \vec{M_i} T_{ij}^{damp} \vec{M_j} \vec{M} = \left( Q, \vec{\mu_{perm}}, \bold{\Theta} \right) diff --git a/src/AMOEBA/amoeba_file.cpp b/src/AMOEBA/amoeba_file.cpp index cac59d12b8..dc37eff756 100644 --- a/src/AMOEBA/amoeba_file.cpp +++ b/src/AMOEBA/amoeba_file.cpp @@ -863,7 +863,7 @@ void PairAmoeba::file_ffield(int nwords, char **words) strcmp(words[0],"direct-13-scale") == 0 || strcmp(words[0],"direct-14-scale") == 0) { double tmp = utils::numeric(FLERR,words[1],true,lmp); - if (tmp != 1.0) + if (tmp != 1.0) error->all(FLERR,"AMOEBA FF file direct-scale 1-2, 1-3, 1-4 values should be 1.0"); } else if (strcmp(words[0],"mutual-11-scale") == 0) { @@ -872,7 +872,7 @@ void PairAmoeba::file_ffield(int nwords, char **words) strcmp(words[0],"mutual-13-scale") == 0 || strcmp(words[0],"mutual-14-scale") == 0) { double tmp = utils::numeric(FLERR,words[1],true,lmp); - if (tmp != 1.0) + if (tmp != 1.0) error->all(FLERR,"AMOEBA FF file mutual-scale 1-2, 1-3, 1-4 values should be 1.0"); // error if LAMMPS does not recognize keyword diff --git a/src/AMOEBA/amoeba_multipole.cpp b/src/AMOEBA/amoeba_multipole.cpp index 790a6e6c05..4b12e14957 100644 --- a/src/AMOEBA/amoeba_multipole.cpp +++ b/src/AMOEBA/amoeba_multipole.cpp @@ -498,7 +498,7 @@ void PairAmoeba::multipole_real() vyy = -yr * frcy; vyz = -0.5 * (zr*frcy+yr*frcz); vzz = -zr * frcz; - + virmpole[0] -= vxx; virmpole[1] -= vyy; virmpole[2] -= vzz; @@ -534,7 +534,7 @@ void PairAmoeba::multipole_real() xiy = x[iy][0] - x[i][0]; yiy = x[iy][1] - x[i][1]; ziy = x[iy][2] - x[i][2]; - + vxx = xix*fix[0] + xiy*fiy[0] + xiz*fiz[0]; vxy = 0.5 * (yix*fix[0] + yiy*fiy[0] + yiz*fiz[0] + xix*fix[1] + xiy*fiy[1] + xiz*fiz[1]); @@ -544,7 +544,7 @@ void PairAmoeba::multipole_real() vyz = 0.5 * (zix*fix[1] + ziy*fiy[1] + ziz*fiz[1] + yix*fix[2] + yiy*fiy[2] + yiz*fiz[2]); vzz = zix*fix[2] + ziy*fiy[2] + ziz*fiz[2]; - + virmpole[0] -= vxx; virmpole[1] -= vyy; virmpole[2] -= vzz; diff --git a/src/AMOEBA/amoeba_polar.cpp b/src/AMOEBA/amoeba_polar.cpp index f052e9ebc6..2dbd941649 100644 --- a/src/AMOEBA/amoeba_polar.cpp +++ b/src/AMOEBA/amoeba_polar.cpp @@ -111,7 +111,7 @@ void PairAmoeba::polar() xiy = x[iy][0] - x[i][0]; yiy = x[iy][1] - x[i][1]; ziy = x[iy][2] - x[i][2]; - + vxx = xix*fix[0] + xiy*fiy[0] + xiz*fiz[0]; vyy = yix*fix[1] + yiy*fiy[1] + yiz*fiz[1]; vzz = zix*fix[2] + ziy*fiy[2] + ziz*fiz[2]; @@ -122,7 +122,7 @@ void PairAmoeba::polar() xix*fix[2] + xiy*fiy[2] + xiz*fiz[2]); vyz = 0.5 * (zix*fix[1] + ziy*fiy[1] + ziz*fiz[1] + yix*fix[2] + yiy*fiy[2] + yiz*fiz[2]); - + virpolar[0] -= vxx; virpolar[1] -= vyy; virpolar[2] -= vzz; diff --git a/src/AMOEBA/amoeba_utils.cpp b/src/AMOEBA/amoeba_utils.cpp index 767ceac32b..94a9d7fe51 100644 --- a/src/AMOEBA/amoeba_utils.cpp +++ b/src/AMOEBA/amoeba_utils.cpp @@ -70,7 +70,7 @@ void PairAmoeba::kmpole() flag = 0; // create a sorted version of bond/angle neighs from special[][] - // NOTE: this is to try and do it identically to Tinker + // NOTE: this is to try and do it identically to Tinker // b/c I think in Tinker, atom order matters as to which case is seen fist for (j = 0; j < nspecial[i][0]; j++) diff --git a/src/AMOEBA/pair_amoeba.cpp b/src/AMOEBA/pair_amoeba.cpp index 5c12dc419c..f69600c511 100644 --- a/src/AMOEBA/pair_amoeba.cpp +++ b/src/AMOEBA/pair_amoeba.cpp @@ -232,7 +232,7 @@ PairAmoeba::~PairAmoeba() memory->destroy(qfac); memory->destroy(gridfft1); - + delete m_kspace; delete p_kspace; delete pc_kspace; @@ -489,7 +489,7 @@ void PairAmoeba::finish() double ave; MPI_Allreduce(&time_init,&ave,1,MPI_DOUBLE,MPI_SUM,world); time_init = ave/comm->nprocs; - + MPI_Allreduce(&time_hal,&ave,1,MPI_DOUBLE,MPI_SUM,world); time_hal = ave/comm->nprocs; @@ -2292,7 +2292,7 @@ double PairAmoeba::memory_usage() if (use_ewald || use_dewald) { bytes += (double) 12 * bsordermax * nmax *sizeof(double); // theta123 bytes += (double) 3 * nmax *sizeof(int); // igrid - } + } bytes += (double) nmax * sizeof(int); // numneigh_dipole bytes += (double) nmax * sizeof(int *); // firstneigh_dipole diff --git a/src/AMOEBA/pair_amoeba.h b/src/AMOEBA/pair_amoeba.h index d8c3555c50..6506fbdb33 100644 --- a/src/AMOEBA/pair_amoeba.h +++ b/src/AMOEBA/pair_amoeba.h @@ -332,7 +332,7 @@ class PairAmoeba : public Pair { double *gridfft1; // copy of p_kspace FFT grid double **cmp,**fmp; // Cartesian and fractional multipoles - double **cphi,**fphi; + double **cphi,**fphi; // params for current KSpace solve and FFT being worked on From 86787cfc6cfa19b195fa4ee4e92f2d3642c246a0 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sat, 28 May 2022 11:28:13 -0400 Subject: [PATCH 241/585] whitespace and clang-format for headers --- src/AMOEBA/amoeba_convolution.h | 43 ++-- src/AMOEBA/angle_amoeba.h | 2 +- src/AMOEBA/atom_vec_amoeba.h | 19 +- src/AMOEBA/fix_amoeba_bitorsion.h | 24 +-- src/AMOEBA/improper_amoeba.h | 2 +- src/AMOEBA/pair_amoeba.h | 335 ++++++++++++++---------------- src/AMOEBA/pair_hippo.h | 8 +- 7 files changed, 208 insertions(+), 225 deletions(-) diff --git a/src/AMOEBA/amoeba_convolution.h b/src/AMOEBA/amoeba_convolution.h index 270a501a71..9f6bb27b74 100644 --- a/src/AMOEBA/amoeba_convolution.h +++ b/src/AMOEBA/amoeba_convolution.h @@ -31,42 +31,41 @@ namespace LAMMPS_NS { class AmoebaConvolution : protected Pointers { public: - int nx,ny,nz; + int nx, ny, nz; int order; - int nfft_owned; // owned grid points in FFT decomp - int nxlo_in,nxhi_in,nylo_in,nyhi_in,nzlo_in,nzhi_in; - int nxlo_out,nxhi_out,nylo_out,nyhi_out,nzlo_out,nzhi_out; - int nxlo_fft,nxhi_fft,nylo_fft,nyhi_fft,nzlo_fft,nzhi_fft; + int nfft_owned; // owned grid points in FFT decomp + int nxlo_in, nxhi_in, nylo_in, nyhi_in, nzlo_in, nzhi_in; + int nxlo_out, nxhi_out, nylo_out, nyhi_out, nzlo_out, nzhi_out; + int nxlo_fft, nxhi_fft, nylo_fft, nyhi_fft, nzlo_fft, nzhi_fft; bigint nfft_global; // nx * ny * nz double *grid_brick_start; // lower left corner of (c)grid_brick data - AmoebaConvolution(class LAMMPS *, class Pair *, - int, int, int, int, int); + AmoebaConvolution(class LAMMPS *, class Pair *, int, int, int, int, int); ~AmoebaConvolution(); void *zero(); FFT_SCALAR *pre_convolution(); void *post_convolution(); private: - int which; // caller name for convolution being performed - int flag3d; // 1 if using 3d grid_brick, 0 for 4d cgrid_brick - int nbrick_owned; // owned grid points in brick decomp - int nbrick_ghosts; // owned + ghost brick grid points - int ngrid_either; // max of nbrick_owned or nfft_owned + int which; // caller name for convolution being performed + int flag3d; // 1 if using 3d grid_brick, 0 for 4d cgrid_brick + int nbrick_owned; // owned grid points in brick decomp + int nbrick_ghosts; // owned + ghost brick grid points + int ngrid_either; // max of nbrick_owned or nfft_owned class Pair *amoeba; - class FFT3d *fft1,*fft2; + class FFT3d *fft1, *fft2; class GridComm *gc; class Remap *remap; - double ***grid_brick; // 3d real brick grid with ghosts - double ****cgrid_brick; // 4d complex brick grid with ghosts + double ***grid_brick; // 3d real brick grid with ghosts + double ****cgrid_brick; // 4d complex brick grid with ghosts - FFT_SCALAR *grid_fft; // 3d FFT grid as 1d vector - FFT_SCALAR *cfft; // 3d complex FFT grid as 1d vector + FFT_SCALAR *grid_fft; // 3d FFT grid as 1d vector + FFT_SCALAR *cfft; // 3d complex FFT grid as 1d vector - double *gc_buf1,*gc_buf2; // buffers for GridComm - double *remap_buf; // buffer for Remap + double *gc_buf1, *gc_buf2; // buffers for GridComm + double *remap_buf; // buffer for Remap void *zero_3d(); void *zero_4d(); @@ -79,10 +78,10 @@ class AmoebaConvolution : protected Pointers { // DEBUG - void debug_scalar(int,const char *); - void debug_file(int,const char *); + void debug_scalar(int, const char *); + void debug_file(int, const char *); }; -} +} // namespace LAMMPS_NS #endif diff --git a/src/AMOEBA/angle_amoeba.h b/src/AMOEBA/angle_amoeba.h index 635bd8735e..52376ff1a8 100644 --- a/src/AMOEBA/angle_amoeba.h +++ b/src/AMOEBA/angle_amoeba.h @@ -44,7 +44,7 @@ class AngleAmoeba : public Angle { double *ub_k, *ub_r0; int *setflag_a, *setflag_ba, *setflag_ub; - int enable_angle,enable_urey; + int enable_angle, enable_urey; void tinker_angle(int, int, int, int, int); void tinker_anglep(int, int, int, int, int); diff --git a/src/AMOEBA/atom_vec_amoeba.h b/src/AMOEBA/atom_vec_amoeba.h index 46953020a8..cb1f76cae3 100644 --- a/src/AMOEBA/atom_vec_amoeba.h +++ b/src/AMOEBA/atom_vec_amoeba.h @@ -12,9 +12,9 @@ ------------------------------------------------------------------------- */ #ifdef ATOM_CLASS - -AtomStyle(amoeba,AtomVecAmoeba) - +// clang-format off +AtomStyle(amoeba,AtomVecAmoeba); +// clang-format on #else #ifndef LMP_ATOM_VEC_AMOEBA_H @@ -36,17 +36,16 @@ class AtomVecAmoeba : public AtomVec { void data_atom_post(int); private: - int *num_bond,*num_angle,*num_dihedral,*num_improper; - int **bond_type,**angle_type,**dihedral_type,**improper_type; + int *num_bond, *num_angle, *num_dihedral, *num_improper; + int **bond_type, **angle_type, **dihedral_type, **improper_type; int **nspecial, *nspecial15; - int any_bond_negative,any_angle_negative, - any_dihedral_negative,any_improper_negative; - int bond_per_atom,angle_per_atom,dihedral_per_atom,improper_per_atom; - int *bond_negative,*angle_negative,*dihedral_negative,*improper_negative; + int any_bond_negative, any_angle_negative, any_dihedral_negative, any_improper_negative; + int bond_per_atom, angle_per_atom, dihedral_per_atom, improper_per_atom; + int *bond_negative, *angle_negative, *dihedral_negative, *improper_negative; }; -} +} // namespace LAMMPS_NS #endif #endif diff --git a/src/AMOEBA/fix_amoeba_bitorsion.h b/src/AMOEBA/fix_amoeba_bitorsion.h index c46f0c45dc..929ecb41b3 100644 --- a/src/AMOEBA/fix_amoeba_bitorsion.h +++ b/src/AMOEBA/fix_amoeba_bitorsion.h @@ -93,33 +93,31 @@ class FixAmoebaBiTorsion : public Fix { // BiTorsion grid and spline data int nbitypes; - int *nxgrid,*nygrid; - double **ttx,**tty,**tbf; - double **tbx,**tby,**tbxy; + int *nxgrid, *nygrid; + double **ttx, **tty, **tbf; + double **tbx, **tby, **tbxy; // data from PairAmoeba class Pair *pair; - int *amtype,*atomic_num; + int *amtype, *atomic_num; // local methods void read_grid_data(char *); void create_splines(); - void nspline(int, double *, double *, double *, double *, - double *, double *, double *, double *, double *); - void cspline(int, double *, double *, double *, double *, double *, - double *, double *, double *, double *, double *); + void nspline(int, double *, double *, double *, double *, double *, double *, double *, double *, + double *); + void cspline(int, double *, double *, double *, double *, double *, double *, double *, double *, + double *, double *); void cytsy(int, double *, double *, double *, double *, double *, int &); void cytsyp(int, double *, double *, double *, int &); void cytsys(int, double *, double *, double *, double *, double *); void chkttor(int, int, int, double &, double &, double &); - void bcuint1(double *, double *, double *, double *, - double, double, double, double, double, double, - double &, double &, double &); - void bcucof(double *, double *, double *, double *, double, double, - double [][4]); + void bcuint1(double *, double *, double *, double *, double, double, double, double, double, + double, double &, double &, double &); + void bcucof(double *, double *, double *, double *, double, double, double[][4]); }; } // namespace LAMMPS_NS diff --git a/src/AMOEBA/improper_amoeba.h b/src/AMOEBA/improper_amoeba.h index 74423ac6c9..34ed01ec83 100644 --- a/src/AMOEBA/improper_amoeba.h +++ b/src/AMOEBA/improper_amoeba.h @@ -37,7 +37,7 @@ class ImproperAmoeba : public Improper { protected: int disable; - double opbend_cubic,opbend_quartic,opbend_pentic,opbend_sextic; + double opbend_cubic, opbend_quartic, opbend_pentic, opbend_sextic; double *k; virtual void allocate(); diff --git a/src/AMOEBA/pair_amoeba.h b/src/AMOEBA/pair_amoeba.h index 6506fbdb33..8143326c6f 100644 --- a/src/AMOEBA/pair_amoeba.h +++ b/src/AMOEBA/pair_amoeba.h @@ -12,30 +12,21 @@ ------------------------------------------------------------------------- */ #ifdef PAIR_CLASS - -PairStyle(amoeba,PairAmoeba) - +// clang-format off +PairStyle(amoeba,PairAmoeba); +// clang-format on #else #ifndef LMP_PAIR_AMOEBA_H #define LMP_PAIR_AMOEBA_H +#include "lmpfftsettings.h" #include "pair.h" -#include -#include - -#ifdef FFT_SINGLE -typedef float FFT_SCALAR; -#else -typedef double FFT_SCALAR; -#endif namespace LAMMPS_NS { #define SBBITS15 29 #define NEIGHMASK15 0x1FFFFFFF - //#define SBBITS15 30 - //#define NEIGHMASK15 0x3FFFFFFF class PairAmoeba : public Pair { public: @@ -62,49 +53,49 @@ class PairAmoeba : public Pair { double memory_usage(); protected: - int nmax; // allocation for owned+ghost - int nlocalmax; // allocation for just owned - int cfstyle,crstyle; // style of forward/reverse comm operations + int nmax; // allocation for owned+ghost + int nlocalmax; // allocation for just owned + int cfstyle, crstyle; // style of forward/reverse comm operations int nualt; double electric; - double rotate[3][3]; // rotation matrix + double rotate[3][3]; // rotation matrix - bool amoeba; // which force field: amoeba == true, hippo == false - std::string mystyle; // text label for style + bool amoeba; // which force field: amoeba == true, hippo == false + std::string mystyle; // text label for style int first_flag; // 1 before first init_style() int first_flag_compute; // 1 before first call to compute() int optlevel; // turn on/off components of force field - int hal_flag,repulse_flag,qxfer_flag; - int disp_rspace_flag,disp_kspace_flag; - int polar_rspace_flag,polar_kspace_flag; - int mpole_rspace_flag,mpole_kspace_flag; - int bond_flag,angle_flag,dihedral_flag,improper_flag; - int urey_flag,pitorsion_flag,bitorsion_flag; + int hal_flag, repulse_flag, qxfer_flag; + int disp_rspace_flag, disp_kspace_flag; + int polar_rspace_flag, polar_kspace_flag; + int mpole_rspace_flag, mpole_kspace_flag; + int bond_flag, angle_flag, dihedral_flag, improper_flag; + int urey_flag, pitorsion_flag, bitorsion_flag; // DEBUG timers - double time_init,time_hal,time_repulse,time_disp; - double time_mpole,time_induce,time_polar,time_qxfer; + double time_init, time_hal, time_repulse, time_disp; + double time_mpole, time_induce, time_polar, time_qxfer; // energy/virial components - double ehal,erepulse,edisp,epolar,empole,eqxfer; - double virhal[6],virrepulse[6],virdisp[6],virpolar[6],virmpole[6],virqxfer[6]; + double ehal, erepulse, edisp, epolar, empole, eqxfer; + double virhal[6], virrepulse[6], virdisp[6], virpolar[6], virmpole[6], virqxfer[6]; // scalar values defined in force-field file - char *forcefield; // FF name + char *forcefield; // FF name double am_dielectric; - int opbendtype,vdwtype; - int radius_rule,radius_type,radius_size,epsilon_rule; + int opbendtype, vdwtype; + int radius_rule, radius_type, radius_size, epsilon_rule; - double bond_cubic,bond_quartic; - double angle_cubic,angle_quartic,angle_pentic,angle_sextic; - double opbend_cubic,opbend_quartic,opbend_pentic,opbend_sextic; + double bond_cubic, bond_quartic; + double angle_cubic, angle_quartic, angle_pentic, angle_sextic; + double opbend_cubic, opbend_quartic, opbend_pentic, opbend_sextic; double torsion_unit; int poltyp; @@ -117,178 +108,178 @@ class PairAmoeba : public Pair { double special_polar_piscale[5]; double special_polar_wscale[5]; - double polar_dscale,polar_uscale; + double polar_dscale, polar_uscale; // scalar values defined in keyfile - double dhal,ghal; + double dhal, ghal; - double vdwcut,vdwtaper; - double repcut,reptaper; - double dispcut,disptaper; - double mpolecut,mpoletaper; - double ctrncut,ctrntaper; + double vdwcut, vdwtaper; + double repcut, reptaper; + double dispcut, disptaper; + double mpolecut, mpoletaper; + double ctrncut, ctrntaper; double ewaldcut; double dewaldcut; double usolvcut; - int use_ewald,use_dewald; + int use_ewald, use_dewald; int use_pred; - int politer,polpred; - int pcgprec,pcgguess; + int politer, polpred; + int pcgprec, pcgguess; double pcgpeek; - int tcgnab,optorder; + int tcgnab, optorder; int maxualt; double poleps; double udiag; - int aeewald_key,apewald_key,adewald_key; - int pmegrid_key,dpmegrid_key; + int aeewald_key, apewald_key, adewald_key; + int pmegrid_key, dpmegrid_key; // types and classes - int n_amtype; // # of defined AMOEBA types, 1-N - int n_amclass; // # of defined AMOEBA classes, 1-N - int max_amtype; // allocation length of per-type data - int max_amclass; // allocation length of per-class data + int n_amtype; // # of defined AMOEBA types, 1-N + int n_amclass; // # of defined AMOEBA classes, 1-N + int max_amtype; // allocation length of per-type data + int max_amclass; // allocation length of per-class data - int *amtype_defined; // 1 if type was defined in FF file - int *amclass_defined; // 1 if class was defined in FF file - int *amtype2class; // amt2c[i] = class which type I belongs to + int *amtype_defined; // 1 if type was defined in FF file + int *amclass_defined; // 1 if class was defined in FF file + int *amtype2class; // amt2c[i] = class which type I belongs to // static per-atom properties, must persist as atoms migrate - int index_amtype,index_amgroup,index_redID; - int index_xyzaxis,index_polaxe,index_pval; + int index_amtype, index_amgroup, index_redID; + int index_xyzaxis, index_polaxe, index_pval; - int *amtype; // AMOEBA type, 1 to N_amtype - int *amgroup; // AMOEBA polarization group, 1 to Ngroup + int *amtype; // AMOEBA type, 1 to N_amtype + int *amgroup; // AMOEBA polarization group, 1 to Ngroup - char *id_pole,*id_udalt,*id_upalt; - class FixStore *fixpole; // stores pole = multipole components - class FixStore *fixudalt; // stores udalt = induced dipole history - class FixStore *fixupalt; // stores upalt = induced dipole history + char *id_pole, *id_udalt, *id_upalt; + class FixStore *fixpole; // stores pole = multipole components + class FixStore *fixudalt; // stores udalt = induced dipole history + class FixStore *fixupalt; // stores upalt = induced dipole history // static per-type properties defined in force-field file - int *atomic_num; // atomic number - int *valence; // valence (# of possible bonds) - double *am_mass; // atomic weight - double *am_q; // charge - double **am_mu; // dipole moment + int *atomic_num; // atomic number + int *valence; // valence (# of possible bonds) + double *am_mass; // atomic weight + double *am_q; // charge + double **am_mu; // dipole moment - double *polarity; // for polar - double *pdamp; // for polar - double *thole; // for polar - double *dirdamp; // for polar - int *npolgroup; // # of other types in polarization group, per-type - int **polgroup; // list of other types in polarization group, per-type + double *polarity; // for polar + double *pdamp; // for polar + double *thole; // for polar + double *dirdamp; // for polar + int *npolgroup; // # of other types in polarization group, per-type + int **polgroup; // list of other types in polarization group, per-type - double *sizpr,*dmppr,*elepr; + double *sizpr, *dmppr, *elepr; // multipole frame info for each amtype, read from PRM file - int *nmultiframe; // # of frames for each type - int **mpaxis; // polaxe values - int **xpole,**ypole,**zpole; // other types in xyz dirs for multipole frame - double ***fpole; // 13 values from file - // 0 = monopole, same as q - // 1,2,3 = 3 dipole components - // 4-12 = 9 quadrupole components + int *nmultiframe; // # of frames for each type + int **mpaxis; // polaxe values + int **xpole, **ypole, **zpole; // other types in xyz dirs for multipole frame + double ***fpole; // 13 values from file + // 0 = monopole, same as q + // 1,2,3 = 3 dipole components + // 4-12 = 9 quadrupole components // static per-class properties defined in force-field file - double *vdwl_eps; // Vdwl epsilon for each class of atom - double *vdwl_sigma; // Vdwl sigma for each class of atom - double *kred; // fraction that H atoms move towards bonded atom - // used in Vdwl, 0.0 if not H atom - double *csix,*adisp; // used in dispersion - double *chgct,*dmpct; // used in charge transfer - double *pcore,*palpha; // for multipole + double *vdwl_eps; // Vdwl epsilon for each class of atom + double *vdwl_sigma; // Vdwl sigma for each class of atom + double *kred; // fraction that H atoms move towards bonded atom + // used in Vdwl, 0.0 if not H atom + double *csix, *adisp; // used in dispersion + double *chgct, *dmpct; // used in charge transfer + double *pcore, *palpha; // for multipole - int **vdwl_class_pair; // Vdwl iclass/jclass for pair of classes - double *vdwl_eps_pair; // Vdwl epsilon for pair of classes - double *vdwl_sigma_pair; // Vdwl sigma for pair of classes - int nvdwl_pair; // # of pairwise Vdwl entries in file - int max_vdwl_pair; // size of allocated data for pairwise Vdwl + int **vdwl_class_pair; // Vdwl iclass/jclass for pair of classes + double *vdwl_eps_pair; // Vdwl epsilon for pair of classes + double *vdwl_sigma_pair; // Vdwl sigma for pair of classes + int nvdwl_pair; // # of pairwise Vdwl entries in file + int max_vdwl_pair; // size of allocated data for pairwise Vdwl // vectors and arrays of small size - double *copt,*copm; // 0:optorder in length - double *gear,*aspc; + double *copt, *copm; // 0:optorder in length + double *gear, *aspc; - double *a_ualt,*ap_ualt; // maxualt*(maxualt+1)/2 in length - double *b_ualt,*bp_ualt; // maxualt in length - double **c_ualt,**cp_ualt; // maxualt x maxualt in size - // indices NOT flipped vs Fortran - double *bpred,*bpredp,*bpreds,*bpredps; // maxualt in length + double *a_ualt, *ap_ualt; // maxualt*(maxualt+1)/2 in length + double *b_ualt, *bp_ualt; // maxualt in length + double **c_ualt, **cp_ualt; // maxualt x maxualt in size + // indices NOT flipped vs Fortran + double *bpred, *bpredp, *bpreds, *bpredps; // maxualt in length - double vmsave[6]; // multipole virial saved to use in polar + double vmsave[6]; // multipole virial saved to use in polar - double csixpr; // square of csix for all atoms + double csixpr; // square of csix for all atoms // params common to pairwise terms - double off2,cut2; - double c0,c1,c2,c3,c4,c5; + double off2, cut2; + double c0, c1, c2, c3, c4, c5; // Vdwl hal params - only for AMOEBA - double **radmin,**epsilon; - double **radmin4,**epsilon4; + double **radmin, **epsilon; + double **radmin4, **epsilon4; // peratom values computed each step // none of them persist with atoms // some of them need communication to ghosts - double **rpole; // multipole, comm to ghosts + double **rpole; // multipole, comm to ghosts - int *xaxis2local,*yaxis2local,*zaxis2local; // xyz axis IDs -> local indices - // just for owned atoms - // set to self if not defined + int *xaxis2local, *yaxis2local, *zaxis2local; // xyz axis IDs -> local indices + // just for owned atoms + // set to self if not defined int *red2local; // local indices of ired IDs, computed for owned and ghost double **xred; // altered coords for H atoms for Vdwl, comm to ghosts - double **tq; // torque from pairwise multipole, reverse comm from ghosts + double **tq; // torque from pairwise multipole, reverse comm from ghosts - double **uind,**uinp; // computed by induce, comm to ghosts + double **uind, **uinp; // computed by induce, comm to ghosts double **udirp; - double **rsd,**rsdp; // used by induce, comm to ghosts + double **rsd, **rsdp; // used by induce, comm to ghosts - double **field,**fieldp; // used by induce, reverse comm from ghosts - double ***uopt,***uoptp; // Nlocal x Optorder+1 x 3 arrays + double **field, **fieldp; // used by induce, reverse comm from ghosts + double ***uopt, ***uoptp; // Nlocal x Optorder+1 x 3 arrays - double **ufld,**dufld; // used by polar, reverse comm from ghosts - double **zrsd,**zrsdp; // used by induce, reverse comm from ghosts + double **ufld, **dufld; // used by polar, reverse comm from ghosts + double **zrsd, **zrsdp; // used by induce, reverse comm from ghosts - double ***uad,***uap,***ubd,***ubp; // used by TCG (not for now) + double ***uad, ***uap, ***ubd, ***ubp; // used by TCG (not for now) - double ***fopt,***foptp; // computed in induce, used by polar, if OPT - // Nlocal x optorder x 10 + double ***fopt, ***foptp; // computed in induce, used by polar, if OPT + // Nlocal x optorder x 10 double *poli; - double **conj,**conjp; - double **vec,**vecp; - double **udir,**usum,**usump; + double **conj, **conjp; + double **vec, **vecp; + double **udir, **usum, **usump; - double **fuind,**fuinp; - double **fdip_phi1,**fdip_phi2,**fdip_sum_phi; - double **dipfield1,**dipfield2; + double **fuind, **fuinp; + double **fdip_phi1, **fdip_phi2, **fdip_sum_phi; + double **dipfield1, **dipfield2; - double **fphid,**fphip; - double **fphidp,**cphidp; + double **fphid, **fphip; + double **fphidp, **cphidp; // derived local neighbor lists - int *numneigh_dipole; // number of dipole neighs for each atom - int **firstneigh_dipole; // ptr to each atom's dipole neigh indices - MyPage *ipage_dipole; // pages of neighbor indices for dipole neighs + int *numneigh_dipole; // number of dipole neighs for each atom + int **firstneigh_dipole; // ptr to each atom's dipole neigh indices + MyPage *ipage_dipole; // pages of neighbor indices for dipole neighs - double **firstneigh_dipdip; // ptr to each atom's dip/dip values - MyPage *dpage_dipdip; // pages of dip/dip values for dipole neighs + double **firstneigh_dipdip; // ptr to each atom's dip/dip values + MyPage *dpage_dipdip; // pages of dip/dip values for dipole neighs int *numneigh_precond; // number of precond neighs for each atom int **firstneigh_precond; // ptr to each atom's precond neigh indices @@ -302,61 +293,61 @@ class PairAmoeba : public Pair { // out indices = in + ghost grid cells // fft indices = owned portion of grid in FFT decomp - int nefft1,nefft2,nefft3; // for electrostatic PME operations - int ndfft1,ndfft2,ndfft3; // for dispersion PME operations + int nefft1, nefft2, nefft3; // for electrostatic PME operations + int ndfft1, ndfft2, ndfft3; // for dispersion PME operations - int bseorder; // for electrostatics - int bsporder; // for polarization - int bsdorder; // for dispersion - int bsordermax; // max of 3 bsorder values + int bseorder; // for electrostatics + int bsporder; // for polarization + int bsdorder; // for dispersion + int bsordermax; // max of 3 bsorder values - double aewald; // current Ewald alpha - double aeewald; // for electrostatics - double apewald; // for polarization - double adewald; // for dispersion + double aewald; // current Ewald alpha + double aeewald; // for electrostatics + double apewald; // for polarization + double adewald; // for dispersion - double *bsmod1,*bsmod2,*bsmod3; // B-spline module along abc axes - // set to max of any nfft1,nfft2,nfft3 + double *bsmod1, *bsmod2, *bsmod3; // B-spline module along abc axes + // set to max of any nfft1,nfft2,nfft3 - double ***thetai1,***thetai2,***thetai3; // B-spline coeffs along abc axes - // Nlocal x max bsorder x 4 + double ***thetai1, ***thetai2, ***thetai3; // B-spline coeffs along abc axes + // Nlocal x max bsorder x 4 - int **igrid; // grid indices for each owned particle, Nlocal x 3 + int **igrid; // grid indices for each owned particle, Nlocal x 3 - double **bsbuild; // used internally in bsplgen, max-bsorder x max-bsorder - // indices ARE flipped vs Fortran + double **bsbuild; // used internally in bsplgen, max-bsorder x max-bsorder + // indices ARE flipped vs Fortran // Kspace data for induce and polar - double *qfac; // convoulution pre-factors - double *gridfft1; // copy of p_kspace FFT grid + double *qfac; // convoulution pre-factors + double *gridfft1; // copy of p_kspace FFT grid - double **cmp,**fmp; // Cartesian and fractional multipoles - double **cphi,**fphi; + double **cmp, **fmp; // Cartesian and fractional multipoles + double **cphi, **fphi; // params for current KSpace solve and FFT being worked on - int nfft1,nfft2,nfft3; // size of FFT - int bsorder; // stencil size - double recip[3][3]; // indices NOT flipped vs Fortran - double ctf[10][10]; // indices NOT flipped vs Fortran - double ftc[10][10]; // indices NOT flipped vs Fortran + int nfft1, nfft2, nfft3; // size of FFT + int bsorder; // stencil size + double recip[3][3]; // indices NOT flipped vs Fortran + double ctf[10][10]; // indices NOT flipped vs Fortran + double ftc[10][10]; // indices NOT flipped vs Fortran - class AmoebaConvolution *m_kspace,*p_kspace,*pc_kspace,*d_kspace; - class AmoebaConvolution *i_kspace,*ic_kspace; + class AmoebaConvolution *m_kspace, *p_kspace, *pc_kspace, *d_kspace; + class AmoebaConvolution *i_kspace, *ic_kspace; // FFT grid size factors - int nfactors; // # of factors - int *factors; // list of possible factors (2,3,5) + int nfactors; // # of factors + int *factors; // list of possible factors (2,3,5) // components of force field void hal(); void repulsion(); - void damprep(double, double, double, double, double, double, double, double, - int, double, double, double *); + void damprep(double, double, double, double, double, double, double, double, int, double, double, + double *); void dispersion(); void dispersion_real(); @@ -407,10 +398,8 @@ class PairAmoeba : public Pair { void grid_disp(double ***); void kewald(); - void kewald_parallel(int, int, int, int, - int &, int &, int &, int &, int &, int &, - int &, int &, int &, int &, int &, int &, - int &, int &, int &, int &, int &, int &); + void kewald_parallel(int, int, int, int, int &, int &, int &, int &, int &, int &, int &, int &, + int &, int &, int &, int &, int &, int &, int &, int &, int &, int &); double ewaldcof(double); int factorable(int); @@ -490,12 +479,10 @@ class PairAmoeba : public Pair { // inline function for neighbor list unmasking - inline int sbmask15(int j) const { - return j >> SBBITS15 & 7; - } + inline int sbmask15(int j) const { return j >> SBBITS15 & 7; } }; -} +} // namespace LAMMPS_NS #endif #endif diff --git a/src/AMOEBA/pair_hippo.h b/src/AMOEBA/pair_hippo.h index ac1b65a23a..af54fe071e 100644 --- a/src/AMOEBA/pair_hippo.h +++ b/src/AMOEBA/pair_hippo.h @@ -12,9 +12,9 @@ ------------------------------------------------------------------------- */ #ifdef PAIR_CLASS - -PairStyle(hippo,PairHippo) - +// clang-format off +PairStyle(hippo,PairHippo); +// clang-format on #else #ifndef LMP_PAIR_HIPPO_H @@ -29,7 +29,7 @@ class PairHippo : public PairAmoeba { PairHippo(class LAMMPS *); }; -} +} // namespace LAMMPS_NS #endif #endif From 81c327edd8a583426eadfc117df4da8143f2079a Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sat, 28 May 2022 11:56:26 -0400 Subject: [PATCH 242/585] add missing override. remove redundant functionality and disable warnings differently this removes an inconsistent overload due to mismatch of arguments --- src/DIELECTRIC/pppm_dielectric.cpp | 25 +++---------------------- src/DIELECTRIC/pppm_dielectric.h | 2 -- src/DIELECTRIC/pppm_disp_dielectric.cpp | 25 +++---------------------- src/DIELECTRIC/pppm_disp_dielectric.h | 3 +-- 4 files changed, 7 insertions(+), 48 deletions(-) diff --git a/src/DIELECTRIC/pppm_dielectric.cpp b/src/DIELECTRIC/pppm_dielectric.cpp index 7f32a0a3f3..92bd89ebd9 100644 --- a/src/DIELECTRIC/pppm_dielectric.cpp +++ b/src/DIELECTRIC/pppm_dielectric.cpp @@ -58,6 +58,9 @@ PPPMDielectric::PPPMDielectric(LAMMPS *_lmp) : PPPM(_lmp) phi = nullptr; potflag = 0; + // no warnings about non-neutral systems from qsum_qsq() + warn_nonneutral = 2; + avec = dynamic_cast( atom->style_match("dielectric")); if (!avec) error->all(FLERR,"pppm/dielectric requires atom style dielectric"); } @@ -463,25 +466,3 @@ void PPPMDielectric::slabcorr() efield[i][2] += ffact * eps[i]*(dipole_all - qsum*x[i][2]); } } - -/* ---------------------------------------------------------------------- - compute qsum,qsqsum,q2 and ignore error/warning if not charge neutral - called whenever charges are changed -------------------------------------------------------------------------- */ - -void PPPMDielectric::qsum_qsq() -{ - const double * const q = atom->q; - const int nlocal = atom->nlocal; - double qsum_local(0.0), qsqsum_local(0.0); - - for (int i = 0; i < nlocal; i++) { - qsum_local += q[i]; - qsqsum_local += q[i]*q[i]; - } - - MPI_Allreduce(&qsum_local,&qsum,1,MPI_DOUBLE,MPI_SUM,world); - MPI_Allreduce(&qsqsum_local,&qsqsum,1,MPI_DOUBLE,MPI_SUM,world); - - q2 = qsqsum * force->qqrd2e; -} diff --git a/src/DIELECTRIC/pppm_dielectric.h b/src/DIELECTRIC/pppm_dielectric.h index 92a93daa90..96ebdb1524 100644 --- a/src/DIELECTRIC/pppm_dielectric.h +++ b/src/DIELECTRIC/pppm_dielectric.h @@ -34,8 +34,6 @@ class PPPMDielectric : public PPPM { double *phi; int potflag; // 1/0 if per-atom electrostatic potential phi is needed - void qsum_qsq(); - protected: void slabcorr() override; diff --git a/src/DIELECTRIC/pppm_disp_dielectric.cpp b/src/DIELECTRIC/pppm_disp_dielectric.cpp index e525ba7384..d4d84e0f62 100644 --- a/src/DIELECTRIC/pppm_disp_dielectric.cpp +++ b/src/DIELECTRIC/pppm_disp_dielectric.cpp @@ -65,6 +65,9 @@ PPPMDispDielectric::PPPMDispDielectric(LAMMPS *_lmp) : PPPMDisp(_lmp) mu_flag = 0; + // no warnings about non-neutral systems from qsum_qsq() + warn_nonneutral = 2; + efield = nullptr; phi = nullptr; potflag = 0; @@ -837,25 +840,3 @@ double PPPMDispDielectric::memory_usage() bytes += nmax * sizeof(double); return bytes; } - -/* ---------------------------------------------------------------------- - compute qsum,qsqsum,q2 and give error/warning if not charge neutral - called initially, when particle count changes, when charges are changed -------------------------------------------------------------------------- */ - -void PPPMDispDielectric::qsum_qsq() -{ - const double * const q = atom->q; - const int nlocal = atom->nlocal; - double qsum_local(0.0), qsqsum_local(0.0); - - for (int i = 0; i < nlocal; i++) { - qsum_local += q[i]; - qsqsum_local += q[i]*q[i]; - } - - MPI_Allreduce(&qsum_local,&qsum,1,MPI_DOUBLE,MPI_SUM,world); - MPI_Allreduce(&qsqsum_local,&qsqsum,1,MPI_DOUBLE,MPI_SUM,world); - - q2 = qsqsum * force->qqrd2e; -} diff --git a/src/DIELECTRIC/pppm_disp_dielectric.h b/src/DIELECTRIC/pppm_disp_dielectric.h index b89be02f92..ce20e292aa 100644 --- a/src/DIELECTRIC/pppm_disp_dielectric.h +++ b/src/DIELECTRIC/pppm_disp_dielectric.h @@ -30,8 +30,7 @@ class PPPMDispDielectric : public PPPMDisp { ~PPPMDispDielectric() override; double memory_usage() override; void compute(int, int) override; - void qsum_qsq(); - void slabcorr(int); + void slabcorr(int) override; double **efield; double *phi; From d4f1b702a26020a43d6a15f0de3abfe4f4d2dd39 Mon Sep 17 00:00:00 2001 From: rohskopf Date: Sat, 28 May 2022 10:31:45 -0600 Subject: [PATCH 243/585] Working derivative extraction. --- src/ML-SNAP/compute_snap.cpp | 241 ++++++++++++++++++++++++++++------- src/ML-SNAP/compute_snap.h | 2 + 2 files changed, 200 insertions(+), 43 deletions(-) diff --git a/src/ML-SNAP/compute_snap.cpp b/src/ML-SNAP/compute_snap.cpp index 70464420c2..8572f3b8a4 100644 --- a/src/ML-SNAP/compute_snap.cpp +++ b/src/ML-SNAP/compute_snap.cpp @@ -238,6 +238,7 @@ ComputeSnap::~ComputeSnap() memory->destroy(nneighs); memory->destroy(neighsum); memory->destroy(icounter); + memory->destroy(dbiri); } } @@ -354,10 +355,11 @@ void ComputeSnap::compute_array() //printf("----- NEIGHMASK: %d\n", NEIGHMASK); int ninside; int numneigh_sum = 0; + int dbirj_row_indx; for (int ii = 0; ii < inum; ii++) { int irow = 0; if (bikflag) irow = atom->tag[ilist[ii] & NEIGHMASK]-1; - printf("----- ii, ilist, itag, irow: %d %d %d %d\n", ii, ilist[ii] & NEIGHMASK, atom->tag[ilist[ii]], irow); + printf("----- i, itag: %d %d\n", ilist[ii] & NEIGHMASK, atom->tag[ilist[ii]]); const int i = ilist[ii]; //printf("----- ii, i: %d %d\n", ii, i); //printf("----- mask[i] groupbit: %d %d\n", mask[i], groupbit); @@ -450,9 +452,14 @@ void ComputeSnap::compute_array() icounter starts at zero and ends at (nneighs[j]-1). */ //icounter[atom->tag[j]-1] += 1; - int dbirj_row_indx = 3*neighsum[atom->tag[j]-1] + 3*icounter[atom->tag[j]-1] ; // THIS IS WRONG, SEE NEXT VAR. - printf("jtag, icounter, dbirj_row_indx: %d, %d, %d %d %d\n", atom->tag[j], icounter[atom->tag[j]-1], dbirj_row_indx+0, dbirj_row_indx+1, dbirj_row_indx+2); - icounter[atom->tag[j]-1] += 1; + if (dbirjflag){ + dbirj_row_indx = 3*neighsum[atom->tag[j]-1] + 3*icounter[atom->tag[j]-1] ; // THIS IS WRONG, SEE NEXT VAR. + printf("jtag, icounter, dbirj_row_indx: %d, %d, %d %d %d\n", atom->tag[j], icounter[atom->tag[j]-1], dbirj_row_indx+0, dbirj_row_indx+1, dbirj_row_indx+2); + icounter[atom->tag[j]-1] += 1; + } + //int dbirj_row_indx = 3*neighsum[atom->tag[j]-1] + 3*icounter[atom->tag[j]-1] ; // THIS IS WRONG, SEE NEXT VAR. + //printf("jtag, icounter, dbirj_row_indx: %d, %d, %d %d %d\n", atom->tag[j], icounter[atom->tag[j]-1], dbirj_row_indx+0, dbirj_row_indx+1, dbirj_row_indx+2); + //icounter[atom->tag[j]-1] += 1; /* j is an atom index starting from 0. Use atom->tag[j] to get the atom in the box (index starts at 1). @@ -507,8 +514,12 @@ void ComputeSnap::compute_array() dbirj[dbirj_row_indx+0][icoeff] = snaptr->dblist[icoeff][0]; dbirj[dbirj_row_indx+1][icoeff] = snaptr->dblist[icoeff][1]; dbirj[dbirj_row_indx+2][icoeff] = snaptr->dblist[icoeff][2]; + // Accumulate dBi/dRi = sum (-dBi/dRj) for neighbors j of if i. + dbiri[3*(atom->tag[i]-1)+0][icoeff] -= snaptr->dblist[icoeff][0]; + dbiri[3*(atom->tag[i]-1)+1][icoeff] -= snaptr->dblist[icoeff][1]; + dbiri[3*(atom->tag[i]-1)+2][icoeff] -= snaptr->dblist[icoeff][2]; } - + } if (quadraticflag) { @@ -588,56 +599,185 @@ void ComputeSnap::compute_array() numneigh_sum += ninside; } // for (int ii = 0; ii < inum; ii++) + printf("`-`-`-` snap[50][6]: %f\n", snap[50][6]); + // Check icounter. + /* for (int ii = 0; ii < inum; ii++) { const int i = ilist[ii]; if (mask[i] & groupbit) { printf("icounter[i]: %d\n", icounter[i]); } } + */ - //printf("----- Accumulate bispecturm force contributions to global array.\n"); - // accumulate bispectrum force contributions to global array - //printf("----- ntotal, nmax, natoms: %d %d %d\n", ntotal, nmax, atom->natoms); - for (int itype = 0; itype < atom->ntypes; itype++) { - const int typeoffset_local = ndims_peratom*nperdim*itype; - const int typeoffset_global = nperdim*itype; - //printf("----- nperdim: %d\n", nperdim); - /*nperdim = ncoeff set previsouly*/ - for (int icoeff = 0; icoeff < nperdim; icoeff++) { - //printf("----- icoeff: %d\n", icoeff); - for (int i = 0; i < ntotal; i++) { - double *snadi = snap_peratom[i]+typeoffset_local; - int iglobal = atom->tag[i]; - if (icoeff==4){ - if ( (snadi[icoeff] != 0.0) || (snadi[icoeff+yoffset] != 0.0) || (snadi[icoeff+zoffset] != 0.0) ){ - //printf("%d %d %f %f %f\n", i, iglobal, snadi[icoeff], snadi[icoeff+yoffset], snadi[icoeff+zoffset]); + // Sum all the derivatives we calculated to check usual compute snap output. + if (dbirjflag){ + fh_d = fopen("DEBUG", "w"); + int row_indx=0; + for (int ii=0; iintypes); + //for (int itype = 0; itype < atom->ntypes; itype++) { + for (int itype=0; itype<1; itype++){ + const int typeoffset_local = ndims_peratom*nperdim*itype; + const int typeoffset_global = nperdim*itype; + //printf("----- nperdim: %d\n", nperdim); + /*nperdim = ncoeff set previsouly*/ + for (int icoeff = 0; icoeff < nperdim; icoeff++) { + //printf("----- icoeff: %d\n", icoeff); + for (int i = 0; i < atom->nlocal; i++) { + //printf("i: %d\n", i); + + + for (int jj=0; jjtag[i]-1] + 3*jj; + int irow = dbirj_row_indx+bik_rows; + //printf(" row_indx, irow: %d %d\n", dbirj_row_indx, irow); + snap[irow++][icoeff+typeoffset_global] += dbirj[dbirj_row_indx+0][icoeff]; + //printf(" irow: %d\n", irow); + snap[irow++][icoeff+typeoffset_global] += dbirj[dbirj_row_indx+1][icoeff]; + //printf(" irow: %d\n", irow); + snap[irow][icoeff+typeoffset_global] += dbirj[dbirj_row_indx+2][icoeff]; + } + + + //int dbirj_row_indx = 3*neighsum[atom->tag[i]-1] + 3*icounter[atom->tag[i]-1]; + //printf(" row_indx: %d\n", dbirj_row_indx); + + /* + double *snadi = snap_peratom[i]+typeoffset_local; + int iglobal = atom->tag[i]; + if (icoeff==4){ + if ( (snadi[icoeff] != 0.0) || (snadi[icoeff+yoffset] != 0.0) || (snadi[icoeff+zoffset] != 0.0) ){ + //printf("%d %d %f %f %f\n", i, iglobal, snadi[icoeff], snadi[icoeff+yoffset], snadi[icoeff+zoffset]); + } + } + int irow = 3*(iglobal-1)+bik_rows; + //printf("----- snadi[icoeff]: %f\n", snadi[icoeff]); + snap[irow++][icoeff+typeoffset_global] += snadi[icoeff]; + snap[irow++][icoeff+typeoffset_global] += snadi[icoeff+yoffset]; + snap[irow][icoeff+typeoffset_global] += snadi[icoeff+zoffset]; + */ + } + } + } + + } + + else{ + //printf("----- Accumulate bispecturm force contributions to global array.\n"); + // accumulate bispectrum force contributions to global array + //printf("----- ntotal, nmax, natoms: %d %d %d\n", ntotal, nmax, atom->natoms); + for (int itype = 0; itype < atom->ntypes; itype++) { + const int typeoffset_local = ndims_peratom*nperdim*itype; + const int typeoffset_global = nperdim*itype; + //printf("----- nperdim: %d\n", nperdim); + /*nperdim = ncoeff set previsouly*/ + for (int icoeff = 0; icoeff < nperdim; icoeff++) { + //printf("----- icoeff: %d\n", icoeff); + for (int i = 0; i < ntotal; i++) { + double *snadi = snap_peratom[i]+typeoffset_local; + int iglobal = atom->tag[i]; + if (icoeff==4){ + if ( (snadi[icoeff] != 0.0) || (snadi[icoeff+yoffset] != 0.0) || (snadi[icoeff+zoffset] != 0.0) ){ + //printf("%d %d %f %f %f\n", i, iglobal, snadi[icoeff], snadi[icoeff+yoffset], snadi[icoeff+zoffset]); + } + } + int irow = 3*(iglobal-1)+bik_rows; + //printf("----- snadi[icoeff]: %f\n", snadi[icoeff]); + snap[irow++][icoeff+typeoffset_global] += snadi[icoeff]; + snap[irow++][icoeff+typeoffset_global] += snadi[icoeff+yoffset]; + snap[irow][icoeff+typeoffset_global] += snadi[icoeff+zoffset]; } - int irow = 3*(iglobal-1)+bik_rows; - //printf("----- snadi[icoeff]: %f\n", snadi[icoeff]); - snap[irow++][icoeff+typeoffset_global] += snadi[icoeff]; - snap[irow++][icoeff+typeoffset_global] += snadi[icoeff+yoffset]; - snap[irow][icoeff+typeoffset_global] += snadi[icoeff+zoffset]; } } } +printf("`-`-`-` snap[50][6]: %f\n", snap[50][6]); //printf("----- Accumulate forces to global array.\n"); /* These are the last columns. */ // accumulate forces to global array + if (dbirjflag){ - for (int i = 0; i < atom->nlocal; i++) { - int iglobal = atom->tag[i]; - int irow = 3*(iglobal-1)+bik_rows; - //printf("---- irow: %d\n", irow); - snap[irow++][lastcol] = atom->f[i][0]; - //printf("---- irow: %d\n", irow); - snap[irow++][lastcol] = atom->f[i][1]; - //printf("---- irow: %d\n", irow); - snap[irow][lastcol] = atom->f[i][2]; + } + else{ + for (int i = 0; i < atom->nlocal; i++) { + int iglobal = atom->tag[i]; + int irow = 3*(iglobal-1)+bik_rows; + //printf("---- irow: %d\n", irow); + snap[irow++][lastcol] = atom->f[i][0]; + //printf("---- irow: %d\n", irow); + snap[irow++][lastcol] = atom->f[i][1]; + //printf("---- irow: %d\n", irow); + snap[irow][lastcol] = atom->f[i][2]; + } } // accumulate bispectrum virial contributions to global array @@ -645,9 +785,9 @@ void ComputeSnap::compute_array() dbdotr_compute(); // sum up over all processes - +printf("`-`-`-` snap[50][6]: %f\n", snap[50][6]); +printf("`-`-`-` snapall[50][6]: %f\n", snapall[50][6]); MPI_Allreduce(&snap[0][0],&snapall[0][0],size_array_rows*size_array_cols,MPI_DOUBLE,MPI_SUM,world); - // assign energy to last column for (int i = 0; i < bik_rows; i++) snapall[i][lastcol] = 0; int irow = 0; @@ -679,7 +819,15 @@ void ComputeSnap::compute_array() void ComputeSnap::dbdotr_compute() { double **x = atom->x; - int irow0 = bik_rows+ndims_force*natoms; + + int irow0; + if (dbirjflag){ + irow0 = bik_rows+dbirj_rows; + } + else{ + irow0 = bik_rows+ndims_force*natoms; + } + //int irow0 = bik_rows+ndims_force*natoms; // sum over bispectrum contributions to forces // on all particles including ghosts @@ -713,8 +861,8 @@ void ComputeSnap::get_dbirj_length() { // invoke full neighbor list (will copy or build if necessary) neighbor->build_one(list); - //memory->destroy(snap); - //memory->destroy(snapall); + memory->destroy(snap); + memory->destroy(snapall); dbirj_rows = 0; const int inum = list->inum; const int* const ilist = list->ilist; @@ -727,6 +875,12 @@ void ComputeSnap::get_dbirj_length() memory->create(neighsum, inum, "snap:neighsum"); memory->create(nneighs, inum, "snap:nneighs"); memory->create(icounter, inum, "snap:icounter"); + memory->create(dbiri, 3*inum,ncoeff, "snap:dbiri"); + for (int ii=0; iicreate(dbirj, dbirj_rows, ncoeff, "snap:dbirj"); // Set size array rows which now depends on dbirj_rows. - //size_array_rows = bik_rows+dbirj_rows+ndims_virial; + size_array_rows = bik_rows+dbirj_rows+ndims_virial; //printf("----- dbirj_rows: %d\n", dbirj_rows); //printf("----- end of dbirj length.\n"); - /* + memory->create(snap,size_array_rows,size_array_cols, "snap:snap"); memory->create(snapall,size_array_rows,size_array_cols, "snap:snapall"); array = snapall; - */ + } /* ---------------------------------------------------------------------- diff --git a/src/ML-SNAP/compute_snap.h b/src/ML-SNAP/compute_snap.h index d077b8f463..3b03512efc 100644 --- a/src/ML-SNAP/compute_snap.h +++ b/src/ML-SNAP/compute_snap.h @@ -35,6 +35,7 @@ class ComputeSnap : public Compute { double memory_usage() override; private: + FILE * fh_d; int natoms, nmax, size_peratom, lastcol; int ncoeff, nperdim, yoffset, zoffset; int ndims_peratom, ndims_force, ndims_virial; @@ -57,6 +58,7 @@ class ComputeSnap : public Compute { //int bik_rows; int bikflag, bik_rows, dbirjflag, dbirj_rows; double **dbirj; + double **dbiri; // dBi/dRi = sum(-dBi/dRj) over neighbors j int *nneighs; // number of neighs inside the snap cutoff. int *neighsum; int *icounter; // counting atoms i for each j. From 4c36c79652bffb8cb7e016ecafb27fa15b4d866e Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sat, 28 May 2022 15:03:26 -0400 Subject: [PATCH 244/585] remove feature for automatic jpeg/png/zlib library download and build this is a post-stable feature and would require a general rewrite of offline processing --- cmake/CMakeLists.txt | 58 +++------------------------ cmake/Modules/LAMMPSUtils.cmake | 17 -------- cmake/Modules/Packages/COMPRESS.cmake | 8 +--- cmake/presets/windows.cmake | 1 - doc/src/Build_settings.rst | 13 +++--- 5 files changed, 11 insertions(+), 86 deletions(-) diff --git a/cmake/CMakeLists.txt b/cmake/CMakeLists.txt index 34b5f1344e..2566497c0e 100644 --- a/cmake/CMakeLists.txt +++ b/cmake/CMakeLists.txt @@ -421,55 +421,9 @@ endif() # tweak jpeg library names to avoid linker errors with MinGW cross-compilation set(JPEG_NAMES libjpeg libjpeg-62) find_package(JPEG QUIET) -find_package(PNG QUIET) -find_package(ZLIB QUIET) - -check_for_internet_connection(HAVE_INTERNET) - -# if we have a working internet connection. download and build missing libs -if(HAVE_INTERNET AND (CMAKE_VERSION VERSION_GREATER_EQUAL 3.16)) - include(ExternalCMakeProject) - if(NOT JPEG_FOUND) - set(LIBJPEG_URL https://sourceforge.net/projects/libjpeg-turbo/files/2.1.3/libjpeg-turbo-2.1.3.tar.gz) - set(LIBJPEG_MD5 85244dedeaf06f636a9e7ddea6d236d8) - mark_as_advanced(LIBJPEG_URL) - mark_as_advanced(LIBJPEG_MD5) - ExternalCmakeProject(libjpeg ${LIBJPEG_URL} ${LIBJPEG_MD5} libjpeg-turbo . CMakeLists.jpeg) - add_library(JPEG::JPEG ALIAS jpeg-static) - target_include_directories(lammps PRIVATE "${CMAKE_BINARY_DIR}/_deps/libjpeg-src") - target_include_directories(lammps PRIVATE "${CMAKE_BINARY_DIR}/_deps/libjpeg-build") - set(JPEG_FOUND TRUE) - endif() - if(NOT ZLIB_FOUND) - set(LIBZ_URL http://prdownloads.sourceforge.net/libpng/zlib-1.2.11.tar.gz) - set(LIBZ_MD5 1c9f62f0778697a09d36121ead88e08e) - mark_as_advanced(LIBZ_URL) - mark_as_advanced(LIBZ_MD5) - ExternalCmakeProject(libz ${LIBZ_URL} ${LIBZ_MD5} zlib . CMakeLists.zlib) - add_library(ZLIB::ZLIB ALIAS zlibstatic) - target_include_directories(lammps PRIVATE "${CMAKE_BINARY_DIR}/_deps/libz-src") - target_include_directories(lammps PRIVATE "${CMAKE_BINARY_DIR}/_deps/libz-build") - set(ZLIB_FOUND TRUE) - set(ZLIB_INCLUDE_DIR "${CMAKE_BINARY_DIR}/_deps/libz-src;${CMAKE_BINARY_DIR}/_deps/libz-build") - endif() - if(NOT PNG_FOUND) - set(LIBPNG_URL http://prdownloads.sourceforge.net/libpng/libpng-1.6.37.tar.gz) - set(LIBPNG_MD5 6c7519f6c75939efa0ed3053197abd54) - mark_as_advanced(LIBPNG_URL) - mark_as_advanced(LIBPNG_MD5) - ExternalCmakeProject(libpng ${LIBPNG_URL} ${LIBPNG_MD5} libpng . CMakeLists.png) - add_library(PNG::PNG ALIAS png_static) - target_include_directories(lammps PRIVATE "${CMAKE_BINARY_DIR}/_deps/libpng-src") - target_include_directories(lammps PRIVATE "${CMAKE_BINARY_DIR}/_deps/libpng-build") - set(PNG_FOUND TRUE) - endif() -endif() - option(WITH_JPEG "Enable JPEG support" ${JPEG_FOUND}) if(WITH_JPEG) - if(NOT JPEG_FOUND) - find_package(JPEG REQUIRED) - endif() + find_package(JPEG REQUIRED) target_compile_definitions(lammps PRIVATE -DLAMMPS_JPEG) if(CMAKE_VERSION VERSION_LESS 3.12) target_include_directories(lammps PRIVATE ${JPEG_INCLUDE_DIRS}) @@ -479,18 +433,16 @@ if(WITH_JPEG) endif() endif() +find_package(PNG QUIET) +find_package(ZLIB QUIET) if(PNG_FOUND AND ZLIB_FOUND) option(WITH_PNG "Enable PNG support" ON) else() option(WITH_PNG "Enable PNG support" OFF) endif() if(WITH_PNG) - if(NOT PNG_FOUND) - find_package(PNG REQUIRED) - endif() - if(NOT ZLIB_FOUND) - find_package(ZLIB REQUIRED) - endif() + find_package(PNG REQUIRED) + find_package(ZLIB REQUIRED) target_link_libraries(lammps PRIVATE PNG::PNG ZLIB::ZLIB) target_compile_definitions(lammps PRIVATE -DLAMMPS_PNG) endif() diff --git a/cmake/Modules/LAMMPSUtils.cmake b/cmake/Modules/LAMMPSUtils.cmake index a6df81fa42..943c3d851e 100644 --- a/cmake/Modules/LAMMPSUtils.cmake +++ b/cmake/Modules/LAMMPSUtils.cmake @@ -105,23 +105,6 @@ function(FetchPotentials pkgfolder potfolder) endif() endfunction(FetchPotentials) -# Check and record if we have a working internet connection -function(check_for_internet_connection variable) - message("Checking internet connection... ") - if((CMAKE_SYSTEM_NAME STREQUAL "Windows") AND (NOT CMAKE_CROSSCOMPILING)) - execute_process(COMMAND ping www.google.com -n 2 - OUTPUT_QUIET ERROR_QUIET RESULT_VARIABLE PING_STATUS) - else() - execute_process(COMMAND ping www.google.com -c 2 - OUTPUT_QUIET ERROR_QUIET RESULT_VARIABLE PING_STATUS) - endif() - if(PING_STATUS EQUAL 0) - set(${variable} TRUE PARENT_SCOPE) - else() - set(${variable} FALSE PARENT_SCOPE) - endif() -endfunction(check_for_internet_connection) - # set CMAKE_LINUX_DISTRO and CMAKE_DISTRO_VERSION on Linux if((CMAKE_SYSTEM_NAME STREQUAL "Linux") AND (EXISTS /etc/os-release)) file(STRINGS /etc/os-release distro REGEX "^NAME=") diff --git a/cmake/Modules/Packages/COMPRESS.cmake b/cmake/Modules/Packages/COMPRESS.cmake index 363ee5b79a..bdcf1aa3f8 100644 --- a/cmake/Modules/Packages/COMPRESS.cmake +++ b/cmake/Modules/Packages/COMPRESS.cmake @@ -1,10 +1,4 @@ -if(NOT ZLIB_FOUND) - find_package(ZLIB) - if(NOT ZLIB_FOUND) - message(WARNING "zlib library not found skipping COMPRESS package") - return() - endif() -endif() +find_package(ZLIB REQUIRED) target_link_libraries(lammps PRIVATE ZLIB::ZLIB) find_package(PkgConfig QUIET) diff --git a/cmake/presets/windows.cmake b/cmake/presets/windows.cmake index 5a3ac217f1..ce5387cef9 100644 --- a/cmake/presets/windows.cmake +++ b/cmake/presets/windows.cmake @@ -9,7 +9,6 @@ set(WIN_PACKAGES CLASS2 COLLOID COLVARS - COMPRESS CORESHELL DIELECTRIC DIFFRACTION diff --git a/doc/src/Build_settings.rst b/doc/src/Build_settings.rst index bdae796bae..7e627a052f 100644 --- a/doc/src/Build_settings.rst +++ b/doc/src/Build_settings.rst @@ -297,15 +297,15 @@ requires the following settings: .. code-block:: bash -D WITH_JPEG=value # yes or no - # default = yes + # default = yes if CMake finds JPEG files, else no -D WITH_PNG=value # yes or no - # default = yes + # default = yes if CMake finds PNG and ZLIB files, else no -D WITH_FFMPEG=value # yes or no # default = yes if CMake can find ffmpeg, else no - Usually these settings are all that is needed. If those libraries - or executables are installed but CMake cannot find the graphics header, - library, or executable files, you can set these variables accordingly: + Usually these settings are all that is needed. If CMake cannot + find the graphics header, library, executable files, you can set + these variables: .. code-block:: bash @@ -317,9 +317,6 @@ requires the following settings: -D ZLIB_LIBRARY=path # path to libz.a (.so) file -D FFMPEG_EXECUTABLE=path # path to ffmpeg executable - Otherwise, CMake will attempt to download, build, and link with - jpeg, png, and zlib libraries statically from source code. - .. tab:: Traditional make .. code-block:: make From 5318ce9b7440eeea99423b3e8bec3425330f8db1 Mon Sep 17 00:00:00 2001 From: rohskopf Date: Sat, 28 May 2022 20:08:58 -0600 Subject: [PATCH 245/585] compute snapneigh gets atom and neighbor indices --- src/ML-SNAP/compute_snap.cpp | 18 +- src/ML-SNAP/compute_snapneigh.cpp | 537 ++++++++++++++++++++++++++++++ src/ML-SNAP/compute_snapneigh.h | 73 ++++ 3 files changed, 619 insertions(+), 9 deletions(-) create mode 100644 src/ML-SNAP/compute_snapneigh.cpp create mode 100644 src/ML-SNAP/compute_snapneigh.h diff --git a/src/ML-SNAP/compute_snap.cpp b/src/ML-SNAP/compute_snap.cpp index 8572f3b8a4..d0e4d67578 100644 --- a/src/ML-SNAP/compute_snap.cpp +++ b/src/ML-SNAP/compute_snap.cpp @@ -303,11 +303,13 @@ void ComputeSnap::init_list(int /*id*/, NeighList *ptr) void ComputeSnap::compute_array() { + if (dbirjflag){ printf("----- dbirjflag true.\n"); get_dbirj_length(); printf("----- got dbirj_length\n"); } + printf("----- cutmax cutforce: %f %f\n", cutmax, force->pair->cutforce); //else{ int ntotal = atom->nlocal + atom->nghost; @@ -599,7 +601,8 @@ void ComputeSnap::compute_array() numneigh_sum += ninside; } // for (int ii = 0; ii < inum; ii++) - printf("`-`-`-` snap[50][6]: %f\n", snap[50][6]); + printf("----- bik_rows: %d\n", bik_rows); + printf("----- bikflag: %d\n", bikflag); // Check icounter. /* @@ -680,7 +683,7 @@ void ComputeSnap::compute_array() if (dbirjflag){ - printf("ntypes: %d\n", atom->ntypes); + //printf("ntypes: %d\n", atom->ntypes); //for (int itype = 0; itype < atom->ntypes; itype++) { for (int itype=0; itype<1; itype++){ const int typeoffset_local = ndims_peratom*nperdim*itype; @@ -758,7 +761,6 @@ void ComputeSnap::compute_array() } } -printf("`-`-`-` snap[50][6]: %f\n", snap[50][6]); //printf("----- Accumulate forces to global array.\n"); /* These are the last columns. @@ -861,8 +863,8 @@ void ComputeSnap::get_dbirj_length() { // invoke full neighbor list (will copy or build if necessary) neighbor->build_one(list); - memory->destroy(snap); - memory->destroy(snapall); + //memory->destroy(snap); + //memory->destroy(snapall); dbirj_rows = 0; const int inum = list->inum; const int* const ilist = list->ilist; @@ -947,10 +949,8 @@ void ComputeSnap::get_dbirj_length() //printf("----- dbirj_rows: %d\n", dbirj_rows); //printf("----- end of dbirj length.\n"); - memory->create(snap,size_array_rows,size_array_cols, - "snap:snap"); - memory->create(snapall,size_array_rows,size_array_cols, - "snap:snapall"); + memory->create(snap,size_array_rows,size_array_cols, "snap:snap"); + memory->create(snapall,size_array_rows,size_array_cols, "snap:snapall"); array = snapall; } diff --git a/src/ML-SNAP/compute_snapneigh.cpp b/src/ML-SNAP/compute_snapneigh.cpp new file mode 100644 index 0000000000..dd6146e154 --- /dev/null +++ b/src/ML-SNAP/compute_snapneigh.cpp @@ -0,0 +1,537 @@ +// clang-format off +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + https://www.lammps.org/, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#include "compute_snapneigh.h" + +#include "sna.h" +#include "atom.h" +#include "update.h" +#include "modify.h" +#include "neighbor.h" +#include "neigh_list.h" +#include "force.h" +#include "pair.h" +#include "comm.h" +#include "memory.h" +#include "error.h" + +#include + +using namespace LAMMPS_NS; + +enum{SCALAR,VECTOR,ARRAY}; + +ComputeSnapneigh::ComputeSnapneigh(LAMMPS *lmp, int narg, char **arg) : + Compute(lmp, narg, arg), cutsq(nullptr), list(nullptr), radelem(nullptr), wjelem(nullptr), + sinnerelem(nullptr), dinnerelem(nullptr) +{ + + array_flag = 1; + //vector_flag = 1; + extarray = 0; + + double rfac0, rmin0; + int twojmax, switchflag, bzeroflag, bnormflag, wselfallflag; + + int ntypes = atom->ntypes; + int nargmin = 6+2*ntypes; + + if (narg < nargmin) error->all(FLERR,"Illegal compute snap command"); + + // default values + + rmin0 = 0.0; + switchflag = 1; + bzeroflag = 1; + quadraticflag = 0; + bikflag = 0; + dbirjflag = 0; + chemflag = 0; + bnormflag = 0; + wselfallflag = 0; + switchinnerflag = 0; + nelements = 1; + + // process required arguments + + memory->create(radelem,ntypes+1,"snapneigh:radelem"); // offset by 1 to match up with types + memory->create(wjelem,ntypes+1,"snapneigh:wjelem"); + rcutfac = atof(arg[3]); + rfac0 = atof(arg[4]); + twojmax = atoi(arg[5]); + for (int i = 0; i < ntypes; i++) + radelem[i+1] = atof(arg[6+i]); + for (int i = 0; i < ntypes; i++) + wjelem[i+1] = atof(arg[6+ntypes+i]); + + // construct cutsq + + double cut; + cutmax = 0.0; + memory->create(cutsq,ntypes+1,ntypes+1,"snapneigh:cutsq"); + for (int i = 1; i <= ntypes; i++) { + cut = 2.0*radelem[i]*rcutfac; + printf("cut: %f\n", cut); + if (cut > cutmax) cutmax = cut; + cutsq[i][i] = cut*cut; + for (int j = i+1; j <= ntypes; j++) { + cut = (radelem[i]+radelem[j])*rcutfac; + cutsq[i][j] = cutsq[j][i] = cut*cut; + } + } + + // set local input checks + + int sinnerflag = 0; + int dinnerflag = 0; + + // process optional args + + int iarg = nargmin; + + while (iarg < narg) { + if (strcmp(arg[iarg],"rmin0") == 0) { + if (iarg+2 > narg) + error->all(FLERR,"Illegal compute snap command"); + rmin0 = atof(arg[iarg+1]); + iarg += 2; + } else if (strcmp(arg[iarg],"bzeroflag") == 0) { + if (iarg+2 > narg) + error->all(FLERR,"Illegal compute snap command"); + bzeroflag = atoi(arg[iarg+1]); + iarg += 2; + } else if (strcmp(arg[iarg],"switchflag") == 0) { + if (iarg+2 > narg) + error->all(FLERR,"Illegal compute snap command"); + switchflag = atoi(arg[iarg+1]); + iarg += 2; + } else if (strcmp(arg[iarg],"quadraticflag") == 0) { + if (iarg+2 > narg) + error->all(FLERR,"Illegal compute snap command"); + quadraticflag = atoi(arg[iarg+1]); + iarg += 2; + } else if (strcmp(arg[iarg],"chem") == 0) { + if (iarg+2+ntypes > narg) + error->all(FLERR,"Illegal compute snap command"); + chemflag = 1; + memory->create(map,ntypes+1,"compute_snapneigh:map"); + nelements = utils::inumeric(FLERR,arg[iarg+1],false,lmp); + for (int i = 0; i < ntypes; i++) { + int jelem = utils::inumeric(FLERR,arg[iarg+2+i],false,lmp); + if (jelem < 0 || jelem >= nelements) + error->all(FLERR,"Illegal compute snap command"); + map[i+1] = jelem; + } + iarg += 2+ntypes; + } else if (strcmp(arg[iarg],"bnormflag") == 0) { + if (iarg+2 > narg) + error->all(FLERR,"Illegal compute snap command"); + bnormflag = atoi(arg[iarg+1]); + iarg += 2; + } else if (strcmp(arg[iarg],"wselfallflag") == 0) { + if (iarg+2 > narg) + error->all(FLERR,"Illegal compute snap command"); + wselfallflag = atoi(arg[iarg+1]); + iarg += 2; + } else if (strcmp(arg[iarg],"bikflag") == 0) { + if (iarg+2 > narg) + error->all(FLERR,"Illegal compute snap command"); + bikflag = atoi(arg[iarg+1]); + iarg += 2; + } else if (strcmp(arg[iarg],"dbirjflag") == 0) { + if (iarg+2 > narg) + error->all(FLERR,"Illegal compute snap command"); + dbirjflag = atoi(arg[iarg+1]); + iarg += 2; + } else if (strcmp(arg[iarg],"switchinnerflag") == 0) { + if (iarg+2 > narg) + error->all(FLERR,"Illegal compute snap command"); + switchinnerflag = atoi(arg[iarg+1]); + iarg += 2; + } else if (strcmp(arg[iarg],"sinner") == 0) { + iarg++; + if (iarg+ntypes > narg) + error->all(FLERR,"Illegal compute snap command"); + memory->create(sinnerelem,ntypes+1,"snapneigh:sinnerelem"); + for (int i = 0; i < ntypes; i++) + sinnerelem[i+1] = utils::numeric(FLERR,arg[iarg+i],false,lmp); + sinnerflag = 1; + iarg += ntypes; + } else if (strcmp(arg[iarg],"dinner") == 0) { + iarg++; + if (iarg+ntypes > narg) + error->all(FLERR,"Illegal compute snap command"); + memory->create(dinnerelem,ntypes+1,"snapneigh:dinnerelem"); + for (int i = 0; i < ntypes; i++) + dinnerelem[i+1] = utils::numeric(FLERR,arg[iarg+i],false,lmp); + dinnerflag = 1; + iarg += ntypes; + } else error->all(FLERR,"Illegal compute snap command"); + } + + if (switchinnerflag && !(sinnerflag && dinnerflag)) + error->all(FLERR,"Illegal compute snap command: switchinnerflag = 1, missing sinner/dinner keyword"); + + if (!switchinnerflag && (sinnerflag || dinnerflag)) + error->all(FLERR,"Illegal compute snap command: switchinnerflag = 0, unexpected sinner/dinner keyword"); + + /* + snaptr = new SNA(lmp, rfac0, twojmax, + rmin0, switchflag, bzeroflag, + chemflag, bnormflag, wselfallflag, + nelements, switchinnerflag); + */ + + //ncoeff = snaptr->ncoeff; + nperdim = ncoeff; + if (quadraticflag) nperdim += (ncoeff*(ncoeff+1))/2; + ndims_force = 3; + ndims_virial = 6; + yoffset = nperdim; + zoffset = 2*nperdim; + natoms = atom->natoms; + bik_rows = 1; + if (bikflag) bik_rows = natoms; + //size_array_rows = bik_rows+ndims_force*natoms+ndims_virial; + dbirj_rows = ndims_force*natoms; + size_array_rows = bik_rows+dbirj_rows+ndims_virial; + size_array_cols = nperdim*atom->ntypes+1; + lastcol = size_array_cols-1; + + ndims_peratom = ndims_force; + size_peratom = ndims_peratom*nperdim*atom->ntypes; + + nmax = 0; + +} + +/* ---------------------------------------------------------------------- */ + +ComputeSnapneigh::~ComputeSnapneigh() +{ + + memory->destroy(neighs); + memory->destroy(radelem); + memory->destroy(wjelem); + memory->destroy(cutsq); + //delete snaptr; + + if (chemflag) memory->destroy(map); + + if (switchinnerflag) { + memory->destroy(sinnerelem); + memory->destroy(dinnerelem); + } + + if (dbirjflag){ + printf("dbirj_rows: %d\n", dbirj_rows); + memory->destroy(dbirj); + memory->destroy(nneighs); + memory->destroy(neighsum); + memory->destroy(icounter); + memory->destroy(dbiri); + } +} + +/* ---------------------------------------------------------------------- */ + +void ComputeSnapneigh::init() +{ + if (force->pair == nullptr) + error->all(FLERR,"Compute snap requires a pair style be defined"); + + if (cutmax > force->pair->cutforce){ + //printf("----- cutmax cutforce: %f %f\n", cutmax, force->pair->cutforce); + error->all(FLERR,"Compute snap cutoff is longer than pairwise cutoff"); + } + + // need an occasional full neighbor list + + neighbor->add_request(this, NeighConst::REQ_FULL | NeighConst::REQ_OCCASIONAL); + +} + + +/* ---------------------------------------------------------------------- */ + +void ComputeSnapneigh::init_list(int /*id*/, NeighList *ptr) +{ + list = ptr; +} + +/* ---------------------------------------------------------------------- */ + +void ComputeSnapneigh::compute_array() +{ + + if (dbirjflag){ + printf("----- dbirjflag true.\n"); + get_dbirj_length(); + printf("----- got dbirj_length\n"); + } + + printf("----- cutmax cutforce: %f %f\n", cutmax, force->pair->cutforce); + //else{ + int ntotal = atom->nlocal + atom->nghost; + + invoked_array = update->ntimestep; + + // invoke full neighbor list (will copy or build if necessary) + neighbor->build_one(list); + + const int inum = list->inum; + const int* const ilist = list->ilist; + const int* const numneigh = list->numneigh; + int** const firstneigh = list->firstneigh; + int * const type = atom->type; + + // compute sna derivatives for each atom in group + // use full neighbor list to count atoms less than cutoff + + double** const x = atom->x; + const int* const mask = atom->mask; + //printf("----- inum: %d\n", inum); + //printf("----- NEIGHMASK: %d\n", NEIGHMASK); + int ninside; + int numneigh_sum = 0; + int dbirj_row_indx; + for (int ii = 0; ii < inum; ii++) { + int irow = 0; + if (bikflag) irow = atom->tag[ilist[ii] & NEIGHMASK]-1; + //printf("----- i, itag: %d %d\n", ilist[ii] & NEIGHMASK, atom->tag[ilist[ii]]); + const int i = ilist[ii]; + //printf("----- ii, i: %d %d\n", ii, i); + //printf("----- mask[i] groupbit: %d %d\n", mask[i], groupbit); + if (mask[i] & groupbit) { + + const double xtmp = x[i][0]; + const double ytmp = x[i][1]; + const double ztmp = x[i][2]; + const int itype = type[i]; + int ielem = 0; + if (chemflag) + ielem = map[itype]; + const double radi = radelem[itype]; + const int* const jlist = firstneigh[i]; + const int jnum = numneigh[i]; + const int typeoffset_local = ndims_peratom*nperdim*(itype-1); + const int typeoffset_global = nperdim*(itype-1); + + // insure rij, inside, and typej are of size jnum + + //snaptr->grow_rij(jnum); + + // rij[][3] = displacements between atom I and those neighbors + // inside = indices of neighbors of I within cutoff + // typej = types of neighbors of I within cutoff + // note Rij sign convention => dU/dRij = dU/dRj = -dU/dRi + + /* + This loop assigns quantities in snaptr. + snaptr is a SNA class instance, see sna.h + + */ + //int ninside = 0; + ninside=0; + for (int jj = 0; jj < jnum; jj++) { + int j = jlist[jj]; + j &= NEIGHMASK; + + const double delx = x[j][0] - xtmp; + const double dely = x[j][1] - ytmp; + const double delz = x[j][2] - ztmp; + const double rsq = delx*delx + dely*dely + delz*delz; + int jtype = type[j]; + int jelem = 0; + if (chemflag) + jelem = map[jtype]; + if (rsq < cutsq[itype][jtype]&&rsq>1e-20) { + if (dbirjflag){ + dbirj_row_indx = 3*neighsum[atom->tag[j]-1] + 3*icounter[atom->tag[j]-1] ; // THIS IS WRONG, SEE NEXT VAR. + //printf("jtag, icounter, dbirj_row_indx: %d, %d, %d %d %d\n", atom->tag[j], icounter[atom->tag[j]-1], dbirj_row_indx+0, dbirj_row_indx+1, dbirj_row_indx+2); + icounter[atom->tag[j]-1] += 1; + + neighs[dbirj_row_indx+0][0] = atom->tag[i]; + neighs[dbirj_row_indx+1][0] = atom->tag[i]; + neighs[dbirj_row_indx+2][0] = atom->tag[i]; + + neighs[dbirj_row_indx+0][1] = atom->tag[j]; + neighs[dbirj_row_indx+1][1] = atom->tag[j]; + neighs[dbirj_row_indx+2][1] = atom->tag[j]; + } + } + } + + // for (int jj = 0; jj < ninside; jj++) + //printf("---- irow after jj loop: %d\n", irow); + + } + + numneigh_sum += ninside; + } // for (int ii = 0; ii < inum; ii++) + + + // Check icounter. + /* + for (int ii = 0; ii < inum; ii++) { + const int i = ilist[ii]; + if (mask[i] & groupbit) { + printf("icounter[i]: %d\n", icounter[i]); + } + } + */ + + + // sum up over all processes + // I'll need to do something like this... + /* + MPI_Allreduce(&snap[0][0],&snapall[0][0],size_array_rows*size_array_cols,MPI_DOUBLE,MPI_SUM,world); + // assign energy to last column + for (int i = 0; i < bik_rows; i++) snapall[i][lastcol] = 0; + int irow = 0; + double reference_energy = c_pe->compute_scalar(); + snapall[irow][lastcol] = reference_energy; + */ + + + for (int i=0; ibuild_one(list); + dbirj_rows = 0; + const int inum = list->inum; + const int* const ilist = list->ilist; + const int* const numneigh = list->numneigh; + int** const firstneigh = list->firstneigh; + int * const type = atom->type; + const int* const mask = atom->mask; + double** const x = atom->x; + //printf("----- inum: %d\n", inum); + memory->create(neighsum, inum, "snapneigh:neighsum"); + memory->create(nneighs, inum, "snapneigh:nneighs"); + memory->create(icounter, inum, "snapneigh:icounter"); + memory->create(dbiri, 3*inum,ncoeff, "snapneigh:dbiri"); + for (int ii=0; ii1e-20) { + dbirj_rows += 1; //jnum + 1; + jnum_cutoff += 1; + nneighs[i]+=1; + } + } + //printf("----- jnum_cutoff: %d\n", jnum_cutoff); + } + } + + dbirj_rows *= ndims_force; + + // Loop over all atoms again to calculate neighsum. + for (int ii = 0; ii < inum; ii++) { + const int i = ilist[ii]; + if (mask[i] & groupbit) { + //printf("nneighs[i]: %d\n", nneighs[i]); + //neighsum[i] = 0; + //printf("i nneighs[i]: %d %d\n", i, nneighs[i]); + if (i==0){ + neighsum[i]=0; + } + else{ + for (int jj=0; jj < ii; jj++){ + const int j = ilist[jj]; + if (mask[j] & groupbit) { + //printf(" j nneighs[j-1]: %d %d\n", j, nneighs[j]); + neighsum[i] += nneighs[j]; + } + } + //neighsum[i] += 1; // Add 1 for the self term dBi/dRi + } + } + //printf("%d\n", neighsum[i]); + } + + memory->create(dbirj, dbirj_rows, ncoeff, "snapneigh:dbirj"); + memory->create(neighs, dbirj_rows, 2, "snapneigh:neighs"); + size_array_rows = dbirj_rows; + size_array_cols = 2; + //vector = neighs; + array = neighs; + // Set size array rows which now depends on dbirj_rows. + //size_array_rows = bik_rows+dbirj_rows+ndims_virial; + //printf("----- dbirj_rows: %d\n", dbirj_rows); + //printf("----- end of dbirj length.\n"); + +} + +/* ---------------------------------------------------------------------- + compute array length +------------------------------------------------------------------------- */ + +double ComputeSnapneigh::compute_scalar() +{ + if (dbirjflag) get_dbirj_length(); + return size_array_rows; +} + +/* ---------------------------------------------------------------------- + memory usage +------------------------------------------------------------------------- */ + +double ComputeSnapneigh::memory_usage() +{ + + double bytes = (double)size_array_rows*size_array_cols * + sizeof(double); // array + + return bytes; +} diff --git a/src/ML-SNAP/compute_snapneigh.h b/src/ML-SNAP/compute_snapneigh.h new file mode 100644 index 0000000000..1ac712a101 --- /dev/null +++ b/src/ML-SNAP/compute_snapneigh.h @@ -0,0 +1,73 @@ +/* -*- c++ -*- ---------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + https://www.lammps.org/, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#ifdef COMPUTE_CLASS +// clang-format off +ComputeStyle(snapneigh,ComputeSnapneigh); +// clang-format on +#else + +#ifndef LMP_COMPUTE_SNAPNEIGH_H +#define LMP_COMPUTE_SNAPNEIGH_H + +#include "compute.h" + +namespace LAMMPS_NS { + +class ComputeSnapneigh : public Compute { + public: + ComputeSnapneigh(class LAMMPS *, int, char **); + ~ComputeSnapneigh() override; + void init() override; + void init_list(int, class NeighList *) override; + void compute_array() override; + double compute_scalar() override; + double memory_usage() override; + + private: + FILE * fh_d; + int natoms, nmax, size_peratom, lastcol; + int ncoeff, nperdim, yoffset, zoffset; + int ndims_peratom, ndims_force, ndims_virial; + double **cutsq; + class NeighList *list; + double **snap, **snapall; + double **snap_peratom; + double rcutfac; + double *radelem; + double *wjelem; + int *map; // map types to [0,nelements) + int nelements, chemflag; + int switchinnerflag; + double *sinnerelem; + double *dinnerelem; + //class SNA *snaptr; + double cutmax; + int quadraticflag; + //int bikflag; + //int bik_rows; + int bikflag, bik_rows, dbirjflag, dbirj_rows; + double **dbirj; + double **dbiri; // dBi/dRi = sum(-dBi/dRj) over neighbors j + int *nneighs; // number of neighs inside the snap cutoff. + int *neighsum; + int *icounter; // counting atoms i for each j. + double **neighs; // neighborlist for neural networks + + void get_dbirj_length(); +}; + +} // namespace LAMMPS_NS + +#endif +#endif From 90730f0d3c14b0143d33e02aea9026301a64ed3c Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sun, 29 May 2022 02:01:21 -0400 Subject: [PATCH 246/585] update windows version history --- src/platform.cpp | 6 ++++++ unittest/python/python-capabilities.py | 1 + 2 files changed, 7 insertions(+) diff --git a/src/platform.cpp b/src/platform.cpp index 5e396d3f63..667481b94d 100644 --- a/src/platform.cpp +++ b/src/platform.cpp @@ -195,6 +195,8 @@ std::string platform::os_info() if (build == "6002") { buf = "Windows Vista"; + } else if (build == "6003") { + buf = "Windows Server 2008"; } else if (build == "7601") { buf = "Windows 7"; } else if (build == "9200") { @@ -227,8 +229,12 @@ std::string platform::os_info() buf = "Windows 10 21H1"; } else if (build == "19044") { buf = "Windows 10 21H2"; + } else if (build == "20348") { + buf = "Windows Server 2022"; } else if (build == "22000") { buf = "Windows 11 21H2"; + } else if (build == "22621") { + buf = "Windows 11 22H2"; } else { const char *entry = "ProductName"; RegGetValue(HKEY_LOCAL_MACHINE, subkey, entry, RRF_RT_REG_SZ, nullptr, &value, diff --git a/unittest/python/python-capabilities.py b/unittest/python/python-capabilities.py index 4c14cac37d..3ac66ebdc6 100644 --- a/unittest/python/python-capabilities.py +++ b/unittest/python/python-capabilities.py @@ -38,6 +38,7 @@ class PythonCapabilities(unittest.TestCase): system = platform.system() osinfo = self.lmp.get_os_info() + print("System: %s LAMMPS OS Info: %s" % (system, osinfo)) self.assertEqual(osinfo.find(system),0) def test_has_gzip_support(self): From 562cd12d8223ad662244a74f1c912b50f4e7c221 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sun, 29 May 2022 15:04:41 -0400 Subject: [PATCH 247/585] revert github action build to LAMMPS repo and develop branch --- .github/workflows/compile-msvc.yml | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/.github/workflows/compile-msvc.yml b/.github/workflows/compile-msvc.yml index 405bb46ae6..15fcf1099d 100644 --- a/.github/workflows/compile-msvc.yml +++ b/.github/workflows/compile-msvc.yml @@ -3,14 +3,14 @@ name: "Native Windows Compilation and Unit Tests" on: push: - branches: [collected-small-changes] + branches: [develop] workflow_dispatch: jobs: build: name: Windows Compilation Test - if: ${{ github.repository == 'akohlmey/lammps' }} + if: ${{ github.repository == 'lammps/lammps' }} runs-on: windows-latest steps: From fa79a6673412959960058d869b778642939afda6 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sun, 29 May 2022 19:53:11 -0400 Subject: [PATCH 248/585] feof() returns non-zero not necessarily 1 --- unittest/formats/test_text_file_reader.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/unittest/formats/test_text_file_reader.cpp b/unittest/formats/test_text_file_reader.cpp index 4965daab5d..325166a2b4 100644 --- a/unittest/formats/test_text_file_reader.cpp +++ b/unittest/formats/test_text_file_reader.cpp @@ -111,7 +111,7 @@ TEST_F(TextFileReaderTest, usefp) delete reader; // check that we reached EOF and the destructor didn't close the file. - ASSERT_EQ(feof(fp), 1); + ASSERT_NE(feof(fp), 0); ASSERT_EQ(fclose(fp), 0); } From cc86e9e8a8b667cba0a46a23f8bb497db9d80c7e Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sun, 29 May 2022 19:56:39 -0400 Subject: [PATCH 249/585] remove windows+gcc test (for now) --- .github/workflows/unittest-gcc.yml | 50 ------------------------------ 1 file changed, 50 deletions(-) delete mode 100644 .github/workflows/unittest-gcc.yml diff --git a/.github/workflows/unittest-gcc.yml b/.github/workflows/unittest-gcc.yml deleted file mode 100644 index a8dcdff07d..0000000000 --- a/.github/workflows/unittest-gcc.yml +++ /dev/null @@ -1,50 +0,0 @@ -# GitHub action to build LAMMPS on Windows with GCC and Ninja -name: "Native Windows Compilation /w GCC and Unit Tests using Ninja" - -on: - push: - branches: [collected-small-changes] - -jobs: - build: - name: Windows Compilation Test - if: ${{ github.repository == 'akohlmey/lammps' }} - runs-on: windows-latest - - steps: - - name: Checkout repository - uses: actions/checkout@v2 - with: - fetch-depth: 2 - - - name: Select Python version - uses: actions/setup-python@v2 - with: - python-version: '3.10' - - - name: Building LAMMPS via CMake - shell: bash - run: | - choco install ninja - python3 -m pip install numpy - python3 -m pip install pyyaml - cmake -C cmake/presets/windows.cmake \ - -D PKG_PYTHON=on \ - -S cmake -B build \ - -D BUILD_SHARED_LIBS=on \ - -D LAMMPS_EXCEPTIONS=on \ - -D ENABLE_TESTING=on \ - -D CMAKE_BUILD_TYPE=Release \ - -G Ninja - cmake --build build - - - name: Run LAMMPS executable - shell: bash - run: | - ./build/lmp.exe -h - ./build/lmp.exe -in bench/in.lj - - - name: Run Unit Tests - working-directory: build - shell: bash - run: ctest -V From 3f332ab0c1cc2d9ed1320678b3b45ba0af03a5a6 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 31 May 2022 06:51:13 -0400 Subject: [PATCH 250/585] step version strings for next patch release --- doc/lammps.1 | 4 ++-- src/version.h | 2 +- 2 files changed, 3 insertions(+), 3 deletions(-) diff --git a/doc/lammps.1 b/doc/lammps.1 index 8ce751844a..51317d8a03 100644 --- a/doc/lammps.1 +++ b/doc/lammps.1 @@ -1,7 +1,7 @@ -.TH LAMMPS "1" "4 May 2022" "2022-5-4" +.TH LAMMPS "1" "31 May 2022" "2022-5-31" .SH NAME .B LAMMPS -\- Molecular Dynamics Simulator. Version 24 March 2022 +\- Molecular Dynamics Simulator. Version 31 May 2022 .SH SYNOPSIS .B lmp diff --git a/src/version.h b/src/version.h index 9de4ec5d9f..13ed8f12c4 100644 --- a/src/version.h +++ b/src/version.h @@ -1 +1 @@ -#define LAMMPS_VERSION "4 May 2022" +#define LAMMPS_VERSION "31 May 2022" From de5c2629ac9635431eaad4c451437d28996490e5 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 31 May 2022 06:53:19 -0400 Subject: [PATCH 251/585] small tweak --- doc/src/Intro_citing.rst | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/doc/src/Intro_citing.rst b/doc/src/Intro_citing.rst index 9f761a7616..e10b1857f1 100644 --- a/doc/src/Intro_citing.rst +++ b/doc/src/Intro_citing.rst @@ -30,8 +30,8 @@ initial versions of LAMMPS is: `S. Plimpton, Fast Parallel Algorithms for Short-Range Molecular Dynamics, J Comp Phys, 117, 1-19 (1995). `_ -DOI for the LAMMPS code -^^^^^^^^^^^^^^^^^^^^^^^ +DOI for the LAMMPS source code +^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^ LAMMPS developers use the `Zenodo service at CERN `_ to create digital object identifies (DOI) for stable releases of the From b8599ccb422657154e98fcd0e2b139076565ba64 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 31 May 2022 11:52:16 -0400 Subject: [PATCH 252/585] fix small local vs. ghost atom access inconsistency in pair style bop --- src/MANYBODY/pair_bop.cpp | 21 +++++++++++++++++++-- 1 file changed, 19 insertions(+), 2 deletions(-) diff --git a/src/MANYBODY/pair_bop.cpp b/src/MANYBODY/pair_bop.cpp index 2a9702507d..b1d128db24 100644 --- a/src/MANYBODY/pair_bop.cpp +++ b/src/MANYBODY/pair_bop.cpp @@ -200,6 +200,7 @@ void PairBOP::compute(int eflag, int vflag) int newton_pair = force->newton_pair; int nlocal = atom->nlocal; + double **x = atom->x; double **f = atom->f; int *type = atom->type; tagint *tag = atom->tag; @@ -223,7 +224,15 @@ void PairBOP::compute(int eflag, int vflag) temp_ij = BOP_index[i] + jj; j = ilist[neigh_index[temp_ij]]; j_tag = tag[j]; - if (j_tag <= i_tag) continue; + if (i_tag > j_tag) { + if ((i_tag+j_tag) % 2 == 0) continue; + } else if (i_tag < j_tag) { + if ((i_tag+j_tag) % 2 == 1) continue; + } else { + if (x[j][2] < x[i][2]) continue; + if (x[j][2] == x[i][2] && x[j][1] < x[i][1]) continue; + if (x[j][2] == x[i][2] && x[j][1] == x[i][1] && x[j][0] < x[i][0]) continue; + } jtype = map[type[j]]; int param_ij = elem2param[itype][jtype]; sigB_0 = SigmaBo(ii,jj); @@ -253,7 +262,15 @@ void PairBOP::compute(int eflag, int vflag) temp_ij = BOP_index2[i] + jj; j = ilist[neigh_index2[temp_ij]]; j_tag = tag[j]; - if (j_tag <= i_tag) continue; + if (i_tag > j_tag) { + if ((i_tag+j_tag) % 2 == 0) continue; + } else if (i_tag < j_tag) { + if ((i_tag+j_tag) % 2 == 1) continue; + } else { + if (x[j][2] < x[i][2]) continue; + if (x[j][2] == x[i][2] && x[j][1] < x[i][1]) continue; + if (x[j][2] == x[i][2] && x[j][1] == x[i][1] && x[j][0] < x[i][0]) continue; + } PairList2 & p2_ij = pairlist2[temp_ij]; dpr2 = -p2_ij.dRep / p2_ij.r; ftmp1 = dpr2 * p2_ij.dis[0]; From 77835a4258e2d1551c6685f695006ff10ff97885 Mon Sep 17 00:00:00 2001 From: Stan Gerald Moore Date: Tue, 31 May 2022 12:36:04 -0600 Subject: [PATCH 253/585] Port changes in #3280 to Kokkos --- src/KOKKOS/pair_reaxff_kokkos.cpp | 794 +++++++++++++-------------- src/REAXFF/reaxff_defs.h | 2 + src/REAXFF/reaxff_torsion_angles.cpp | 17 +- 3 files changed, 404 insertions(+), 409 deletions(-) diff --git a/src/KOKKOS/pair_reaxff_kokkos.cpp b/src/KOKKOS/pair_reaxff_kokkos.cpp index 61f3bb3037..c7924773a9 100644 --- a/src/KOKKOS/pair_reaxff_kokkos.cpp +++ b/src/KOKKOS/pair_reaxff_kokkos.cpp @@ -2782,174 +2782,174 @@ void PairReaxFFKokkos::operator()(TagPairReaxComputeAngularPreproces F_FLOAT fitmp[3],fjtmp[3]; for (int j = 0; j < 3; j++) fitmp[j] = 0.0; - delij[0] = x(j,0) - xtmp; - delij[1] = x(j,1) - ytmp; - delij[2] = x(j,2) - ztmp; - const F_FLOAT rsqij = delij[0]*delij[0] + delij[1]*delij[1] + delij[2]*delij[2]; - rij = sqrt(rsqij); - bo_ij = d_BO(i,j_index); + delij[0] = x(j,0) - xtmp; + delij[1] = x(j,1) - ytmp; + delij[2] = x(j,2) - ztmp; + const F_FLOAT rsqij = delij[0]*delij[0] + delij[1]*delij[1] + delij[2]*delij[2]; + rij = sqrt(rsqij); + bo_ij = d_BO(i,j_index); - BOA_ij = bo_ij - thb_cut; + BOA_ij = bo_ij - thb_cut; - const int jtype = type(j); + const int jtype = type(j); - F_FLOAT CdDelta_j = 0.0; - for (int k = 0; k < 3; k++) fjtmp[k] = 0.0; + F_FLOAT CdDelta_j = 0.0; + for (int k = 0; k < 3; k++) fjtmp[k] = 0.0; - delik[0] = x(k,0) - xtmp; - delik[1] = x(k,1) - ytmp; - delik[2] = x(k,2) - ztmp; - const F_FLOAT rsqik = delik[0]*delik[0] + delik[1]*delik[1] + delik[2]*delik[2]; - const F_FLOAT rik = sqrt(rsqik); - bo_ik = d_BO(i,k_index); - BOA_ik = bo_ik - thb_cut; + delik[0] = x(k,0) - xtmp; + delik[1] = x(k,1) - ytmp; + delik[2] = x(k,2) - ztmp; + const F_FLOAT rsqik = delik[0]*delik[0] + delik[1]*delik[1] + delik[2]*delik[2]; + const F_FLOAT rik = sqrt(rsqik); + bo_ik = d_BO(i,k_index); + BOA_ik = bo_ik - thb_cut; - const int ktype = type(k); + const int ktype = type(k); - // theta and derivatives + // theta and derivatives - cos_theta = (delij[0]*delik[0]+delij[1]*delik[1]+delij[2]*delik[2])/(rij*rik); - if (cos_theta > 1.0) cos_theta = 1.0; - if (cos_theta < -1.0) cos_theta = -1.0; - theta = acos(cos_theta); + cos_theta = (delij[0]*delik[0]+delij[1]*delik[1]+delij[2]*delik[2])/(rij*rik); + if (cos_theta > 1.0) cos_theta = 1.0; + if (cos_theta < -1.0) cos_theta = -1.0; + theta = acos(cos_theta); - const F_FLOAT inv_dists = 1.0 / (rij * rik); - const F_FLOAT Cdot_inv3 = cos_theta * inv_dists * inv_dists; + const F_FLOAT inv_dists = 1.0 / (rij * rik); + const F_FLOAT Cdot_inv3 = cos_theta * inv_dists * inv_dists; - for (int t = 0; t < 3; t++) { - dcos_theta_di[t] = -(delik[t] + delij[t]) * inv_dists + Cdot_inv3 * (rsqik * delij[t] + rsqij * delik[t]); - dcos_theta_dj[t] = delik[t] * inv_dists - Cdot_inv3 * rsqik * delij[t]; - dcos_theta_dk[t] = delij[t] * inv_dists - Cdot_inv3 * rsqij * delik[t]; - } + for (int t = 0; t < 3; t++) { + dcos_theta_di[t] = -(delik[t] + delij[t]) * inv_dists + Cdot_inv3 * (rsqik * delij[t] + rsqij * delik[t]); + dcos_theta_dj[t] = delik[t] * inv_dists - Cdot_inv3 * rsqik * delij[t]; + dcos_theta_dk[t] = delij[t] * inv_dists - Cdot_inv3 * rsqij * delik[t]; + } - sin_theta = sin(theta); - if (sin_theta < 1.0e-5) sin_theta = 1.0e-5; - p_val1 = paramsthbp(jtype,itype,ktype).p_val1; + sin_theta = sin(theta); + if (sin_theta < 1.0e-5) sin_theta = 1.0e-5; + p_val1 = paramsthbp(jtype,itype,ktype).p_val1; - // ANGLE ENERGY + // ANGLE ENERGY - p_val1 = paramsthbp(jtype,itype,ktype).p_val1; - p_val2 = paramsthbp(jtype,itype,ktype).p_val2; - p_val4 = paramsthbp(jtype,itype,ktype).p_val4; - p_val7 = paramsthbp(jtype,itype,ktype).p_val7; - theta_00 = paramsthbp(jtype,itype,ktype).theta_00; + p_val1 = paramsthbp(jtype,itype,ktype).p_val1; + p_val2 = paramsthbp(jtype,itype,ktype).p_val2; + p_val4 = paramsthbp(jtype,itype,ktype).p_val4; + p_val7 = paramsthbp(jtype,itype,ktype).p_val7; + theta_00 = paramsthbp(jtype,itype,ktype).theta_00; - exp3ij = exp(-p_val3 * pow(BOA_ij, p_val4)); - f7_ij = 1.0 - exp3ij; - Cf7ij = p_val3 * p_val4 * pow(BOA_ij, p_val4 - 1.0) * exp3ij; - exp3jk = exp(-p_val3 * pow(BOA_ik, p_val4)); - f7_jk = 1.0 - exp3jk; - Cf7jk = p_val3 * p_val4 * pow(BOA_ik, p_val4 - 1.0) * exp3jk; - expval7 = exp(-p_val7 * d_Delta_boc[i]); - trm8 = 1.0 + expval6 + expval7; - f8_Dj = p_val5 - ((p_val5 - 1.0) * (2.0 + expval6) / trm8); - Cf8j = ((1.0 - p_val5) / (trm8*trm8)) * - (p_val6 * expval6 * trm8 - (2.0 + expval6) * (p_val6*expval6 - p_val7*expval7)); - theta_0 = 180.0 - theta_00 * (1.0 - exp(-p_val10 * (2.0 - SBO2))); - theta_0 = theta_0*constPI/180.0; + exp3ij = exp(-p_val3 * pow(BOA_ij, p_val4)); + f7_ij = 1.0 - exp3ij; + Cf7ij = p_val3 * p_val4 * pow(BOA_ij, p_val4 - 1.0) * exp3ij; + exp3jk = exp(-p_val3 * pow(BOA_ik, p_val4)); + f7_jk = 1.0 - exp3jk; + Cf7jk = p_val3 * p_val4 * pow(BOA_ik, p_val4 - 1.0) * exp3jk; + expval7 = exp(-p_val7 * d_Delta_boc[i]); + trm8 = 1.0 + expval6 + expval7; + f8_Dj = p_val5 - ((p_val5 - 1.0) * (2.0 + expval6) / trm8); + Cf8j = ((1.0 - p_val5) / (trm8*trm8)) * + (p_val6 * expval6 * trm8 - (2.0 + expval6) * (p_val6*expval6 - p_val7*expval7)); + theta_0 = 180.0 - theta_00 * (1.0 - exp(-p_val10 * (2.0 - SBO2))); + theta_0 = theta_0*constPI/180.0; - expval2theta = exp(-p_val2 * (theta_0-theta)*(theta_0-theta)); - if (p_val1 >= 0) - expval12theta = p_val1 * (1.0 - expval2theta); - else // To avoid linear Me-H-Me angles (6/6/06) - expval12theta = p_val1 * -expval2theta; + expval2theta = exp(-p_val2 * (theta_0-theta)*(theta_0-theta)); + if (p_val1 >= 0) + expval12theta = p_val1 * (1.0 - expval2theta); + else // To avoid linear Me-H-Me angles (6/6/06) + expval12theta = p_val1 * -expval2theta; - CEval1 = Cf7ij * f7_jk * f8_Dj * expval12theta; - CEval2 = Cf7jk * f7_ij * f8_Dj * expval12theta; - CEval3 = Cf8j * f7_ij * f7_jk * expval12theta; - CEval4 = -2.0 * p_val1 * p_val2 * f7_ij * f7_jk * f8_Dj * expval2theta * (theta_0 - theta); - Ctheta_0 = p_val10 * theta_00*constPI/180.0 * exp(-p_val10 * (2.0 - SBO2)); - CEval5 = -CEval4 * Ctheta_0 * CSBO2; - CEval6 = CEval5 * dSBO1; - CEval7 = CEval5 * dSBO2; - CEval8 = -CEval4 / sin_theta; + CEval1 = Cf7ij * f7_jk * f8_Dj * expval12theta; + CEval2 = Cf7jk * f7_ij * f8_Dj * expval12theta; + CEval3 = Cf8j * f7_ij * f7_jk * expval12theta; + CEval4 = -2.0 * p_val1 * p_val2 * f7_ij * f7_jk * f8_Dj * expval2theta * (theta_0 - theta); + Ctheta_0 = p_val10 * theta_00*constPI/180.0 * exp(-p_val10 * (2.0 - SBO2)); + CEval5 = -CEval4 * Ctheta_0 * CSBO2; + CEval6 = CEval5 * dSBO1; + CEval7 = CEval5 * dSBO2; + CEval8 = -CEval4 / sin_theta; - e_ang = f7_ij * f7_jk * f8_Dj * expval12theta; - if (eflag) ev.ereax[3] += e_ang; + e_ang = f7_ij * f7_jk * f8_Dj * expval12theta; + if (eflag) ev.ereax[3] += e_ang; - // Penalty energy + // Penalty energy - p_pen1 = paramsthbp(jtype,itype,ktype).p_pen1; + p_pen1 = paramsthbp(jtype,itype,ktype).p_pen1; - exp_pen2ij = exp(-p_pen2 * (BOA_ij - 2.0)*(BOA_ij - 2.0)); - exp_pen2jk = exp(-p_pen2 * (BOA_ik - 2.0)*(BOA_ik - 2.0)); - exp_pen3 = exp(-p_pen3 * d_Delta[i]); - exp_pen4 = exp(p_pen4 * d_Delta[i]); - trm_pen34 = 1.0 + exp_pen3 + exp_pen4; - f9_Dj = (2.0 + exp_pen3) / trm_pen34; - Cf9j = (-p_pen3 * exp_pen3 * trm_pen34 - (2.0 + exp_pen3) * - (-p_pen3 * exp_pen3 + p_pen4 * exp_pen4))/(trm_pen34*trm_pen34); + exp_pen2ij = exp(-p_pen2 * (BOA_ij - 2.0)*(BOA_ij - 2.0)); + exp_pen2jk = exp(-p_pen2 * (BOA_ik - 2.0)*(BOA_ik - 2.0)); + exp_pen3 = exp(-p_pen3 * d_Delta[i]); + exp_pen4 = exp(p_pen4 * d_Delta[i]); + trm_pen34 = 1.0 + exp_pen3 + exp_pen4; + f9_Dj = (2.0 + exp_pen3) / trm_pen34; + Cf9j = (-p_pen3 * exp_pen3 * trm_pen34 - (2.0 + exp_pen3) * + (-p_pen3 * exp_pen3 + p_pen4 * exp_pen4))/(trm_pen34*trm_pen34); - e_pen = p_pen1 * f9_Dj * exp_pen2ij * exp_pen2jk; - if (eflag) ev.ereax[4] += e_pen; + e_pen = p_pen1 * f9_Dj * exp_pen2ij * exp_pen2jk; + if (eflag) ev.ereax[4] += e_pen; - CEpen1 = e_pen * Cf9j / f9_Dj; - temp = -2.0 * p_pen2 * e_pen; - CEpen2 = temp * (BOA_ij - 2.0); - CEpen3 = temp * (BOA_ik - 2.0); + CEpen1 = e_pen * Cf9j / f9_Dj; + temp = -2.0 * p_pen2 * e_pen; + CEpen2 = temp * (BOA_ij - 2.0); + CEpen3 = temp * (BOA_ik - 2.0); - // ConjAngle energy + // ConjAngle energy - p_coa1 = paramsthbp(jtype,itype,ktype).p_coa1; - exp_coa2 = exp(p_coa2 * Delta_val); - e_coa = p_coa1 / (1. + exp_coa2) * - exp(-p_coa3 * SQR(d_total_bo[j]-BOA_ij)) * - exp(-p_coa3 * SQR(d_total_bo[k]-BOA_ik)) * - exp(-p_coa4 * SQR(BOA_ij - 1.5)) * - exp(-p_coa4 * SQR(BOA_ik - 1.5)); + p_coa1 = paramsthbp(jtype,itype,ktype).p_coa1; + exp_coa2 = exp(p_coa2 * Delta_val); + e_coa = p_coa1 / (1. + exp_coa2) * + exp(-p_coa3 * SQR(d_total_bo[j]-BOA_ij)) * + exp(-p_coa3 * SQR(d_total_bo[k]-BOA_ik)) * + exp(-p_coa4 * SQR(BOA_ij - 1.5)) * + exp(-p_coa4 * SQR(BOA_ik - 1.5)); - CEcoa1 = -2 * p_coa4 * (BOA_ij - 1.5) * e_coa; - CEcoa2 = -2 * p_coa4 * (BOA_ik - 1.5) * e_coa; - CEcoa3 = -p_coa2 * exp_coa2 * e_coa / (1 + exp_coa2); - CEcoa4 = -2 * p_coa3 * (d_total_bo[j]-BOA_ij) * e_coa; - CEcoa5 = -2 * p_coa3 * (d_total_bo[k]-BOA_ik) * e_coa; + CEcoa1 = -2 * p_coa4 * (BOA_ij - 1.5) * e_coa; + CEcoa2 = -2 * p_coa4 * (BOA_ik - 1.5) * e_coa; + CEcoa3 = -p_coa2 * exp_coa2 * e_coa / (1 + exp_coa2); + CEcoa4 = -2 * p_coa3 * (d_total_bo[j]-BOA_ij) * e_coa; + CEcoa5 = -2 * p_coa3 * (d_total_bo[k]-BOA_ik) * e_coa; - if (eflag) ev.ereax[5] += e_coa; + if (eflag) ev.ereax[5] += e_coa; - // Forces + // Forces - a_Cdbo(i,j_index) += (CEval1 + CEpen2 + (CEcoa1 - CEcoa4)); - a_Cdbo(j,i_index) += (CEval1 + CEpen2 + (CEcoa1 - CEcoa4)); - a_Cdbo(i,k_index) += (CEval2 + CEpen3 + (CEcoa2 - CEcoa5)); - a_Cdbo(k,i_index) += (CEval2 + CEpen3 + (CEcoa2 - CEcoa5)); + a_Cdbo(i,j_index) += (CEval1 + CEpen2 + (CEcoa1 - CEcoa4)); + a_Cdbo(j,i_index) += (CEval1 + CEpen2 + (CEcoa1 - CEcoa4)); + a_Cdbo(i,k_index) += (CEval2 + CEpen3 + (CEcoa2 - CEcoa5)); + a_Cdbo(k,i_index) += (CEval2 + CEpen3 + (CEcoa2 - CEcoa5)); - CdDelta_i += ((CEval3 + CEval7) + CEpen1 + CEcoa3); - CdDelta_j += CEcoa4; - a_CdDelta[k] += CEcoa5; + CdDelta_i += ((CEval3 + CEval7) + CEpen1 + CEcoa3); + CdDelta_j += CEcoa4; + a_CdDelta[k] += CEcoa5; - for (int ll = j_start; ll < j_end; ll++) { - int l = d_bo_list[ll]; - l &= NEIGHMASK; - const int l_index = ll - j_start; + for (int ll = j_start; ll < j_end; ll++) { + int l = d_bo_list[ll]; + l &= NEIGHMASK; + const int l_index = ll - j_start; - temp_bo_jt = d_BO(i,l_index); - temp = temp_bo_jt * temp_bo_jt * temp_bo_jt; - pBOjt7 = temp * temp * temp_bo_jt; + temp_bo_jt = d_BO(i,l_index); + temp = temp_bo_jt * temp_bo_jt * temp_bo_jt; + pBOjt7 = temp * temp * temp_bo_jt; - a_Cdbo(i,l_index) += (CEval6 * pBOjt7); - a_Cdbopi(i,l_index) += CEval5; - a_Cdbopi2(i,l_index) += CEval5; - } + a_Cdbo(i,l_index) += (CEval6 * pBOjt7); + a_Cdbopi(i,l_index) += CEval5; + a_Cdbopi2(i,l_index) += CEval5; + } - for (int d = 0; d < 3; d++) fi_tmp[d] = CEval8 * dcos_theta_di[d]; - for (int d = 0; d < 3; d++) fj_tmp[d] = CEval8 * dcos_theta_dj[d]; - for (int d = 0; d < 3; d++) fk_tmp[d] = CEval8 * dcos_theta_dk[d]; - for (int d = 0; d < 3; d++) fitmp[d] -= fi_tmp[d]; - for (int d = 0; d < 3; d++) fjtmp[d] -= fj_tmp[d]; - for (int d = 0; d < 3; d++) a_f(k,d) -= fk_tmp[d]; + for (int d = 0; d < 3; d++) fi_tmp[d] = CEval8 * dcos_theta_di[d]; + for (int d = 0; d < 3; d++) fj_tmp[d] = CEval8 * dcos_theta_dj[d]; + for (int d = 0; d < 3; d++) fk_tmp[d] = CEval8 * dcos_theta_dk[d]; + for (int d = 0; d < 3; d++) fitmp[d] -= fi_tmp[d]; + for (int d = 0; d < 3; d++) fjtmp[d] -= fj_tmp[d]; + for (int d = 0; d < 3; d++) a_f(k,d) -= fk_tmp[d]; - // energy/virial tally - if (EVFLAG) { - eng_tmp = e_ang + e_pen + e_coa; - //if (eflag_atom) this->template ev_tally(ev,i,j,eng_tmp,0.0,0.0,0.0,0.0); - for (int d = 0; d < 3; d++) delki[d] = -1.0 * delik[d]; - for (int d = 0; d < 3; d++) delji[d] = -1.0 * delij[d]; - if (eflag_atom) this->template e_tally(ev,i,j,eng_tmp); - if (vflag_either) this->template v_tally3(ev,i,j,k,fj_tmp,fk_tmp,delji,delki); - } + // energy/virial tally + if (EVFLAG) { + eng_tmp = e_ang + e_pen + e_coa; + //if (eflag_atom) this->template ev_tally(ev,i,j,eng_tmp,0.0,0.0,0.0,0.0); + for (int d = 0; d < 3; d++) delki[d] = -1.0 * delik[d]; + for (int d = 0; d < 3; d++) delji[d] = -1.0 * delij[d]; + if (eflag_atom) this->template e_tally(ev,i,j,eng_tmp); + if (vflag_either) this->template v_tally3(ev,i,j,k,fj_tmp,fk_tmp,delji,delki); + } - a_CdDelta[j] += CdDelta_j; - for (int d = 0; d < 3; d++) a_f(j,d) += fjtmp[d]; + a_CdDelta[j] += CdDelta_j; + for (int d = 0; d < 3; d++) a_f(j,d) += fjtmp[d]; a_CdDelta[i] += CdDelta_i; for (int d = 0; d < 3; d++) a_f(i,d) += fitmp[d]; } @@ -3019,285 +3019,281 @@ void PairReaxFFKokkos::operator()(TagPairReaxComputeTorsionPreproces const X_FLOAT ztmp = x(i,2); Delta_i = d_Delta_boc[i]; - const int jtype = type(j); - - bo_ij = d_BO(i,j_index); - - delij[0] = x(j,0) - xtmp; - delij[1] = x(j,1) - ytmp; - delij[2] = x(j,2) - ztmp; - const F_FLOAT rsqij = delij[0]*delij[0] + delij[1]*delij[1] + delij[2]*delij[2]; - const F_FLOAT rij = sqrt(rsqij); - - BOA_ij = bo_ij - thb_cut; - Delta_j = d_Delta_boc[j]; - exp_tor2_ij = exp(-p_tor2 * BOA_ij); - exp_cot2_ij = exp(-p_cot2 * SQR(BOA_ij - 1.5)); - exp_tor3_DiDj = exp(-p_tor3 * (Delta_i + Delta_j)); - exp_tor4_DiDj = exp(p_tor4 * (Delta_i + Delta_j)); - exp_tor34_inv = 1.0 / (1.0 + exp_tor3_DiDj + exp_tor4_DiDj); - f11_DiDj = (2.0 + exp_tor3_DiDj) * exp_tor34_inv; - - const int ktype = type(k); - - bo_ik = d_BO(i,k_index); - - BOA_ik = bo_ik - thb_cut; - for (int d = 0; d < 3; d ++) delik[d] = x(k,d) - x(i,d); - const F_FLOAT rsqik = delik[0]*delik[0] + delik[1]*delik[1] + delik[2]*delik[2]; - const F_FLOAT rik = sqrt(rsqik); - - cos_ijk = (delij[0]*delik[0]+delij[1]*delik[1]+delij[2]*delik[2])/(rij*rik); - if (cos_ijk > 1.0) cos_ijk = 1.0; - if (cos_ijk < -1.0) cos_ijk = -1.0; - theta_ijk = acos(cos_ijk); - - // dcos_ijk - const F_FLOAT inv_dists = 1.0 / (rij * rik); - const F_FLOAT cos_ijk_tmp = cos_ijk / ((rij*rik)*(rij*rik)); - - for (int d = 0; d < 3; d++) { - dcos_ijk_di[d] = -(delik[d] + delij[d]) * inv_dists + cos_ijk_tmp * (rsqik * delij[d] + rsqij * delik[d]); - dcos_ijk_dj[d] = delik[d] * inv_dists - cos_ijk_tmp * rsqik * delij[d]; - dcos_ijk_dk[d] = delij[d] * inv_dists - cos_ijk_tmp * rsqij * delik[d]; - } - - sin_ijk = sin(theta_ijk); - if (sin_ijk >= 0 && sin_ijk <= 1e-10) - tan_ijk_i = cos_ijk / 1e-10; - else if (sin_ijk <= 0 && sin_ijk >= -1e-10) - tan_ijk_i = -cos_ijk / 1e-10; - else tan_ijk_i = cos_ijk / sin_ijk; - - exp_tor2_ik = exp(-p_tor2 * BOA_ik); - exp_cot2_ik = exp(-p_cot2 * SQR(BOA_ik -1.5)); - - const int ltype = type(l); - - bo_jl = d_BO(j,l_index); - - for (int d = 0; d < 3; d ++) deljl[d] = x(l,d) - x(j,d); - const F_FLOAT rsqjl = deljl[0]*deljl[0] + deljl[1]*deljl[1] + deljl[2]*deljl[2]; - const F_FLOAT rjl = sqrt(rsqjl); - BOA_jl = bo_jl - thb_cut; - - cos_jil = -(delij[0]*deljl[0]+delij[1]*deljl[1]+delij[2]*deljl[2])/(rij*rjl); - if (cos_jil > 1.0) cos_jil = 1.0; - if (cos_jil < -1.0) cos_jil = -1.0; - theta_jil = acos(cos_jil); - - // dcos_jil - const F_FLOAT inv_distjl = 1.0 / (rij * rjl); - const F_FLOAT cos_jil_tmp = cos_jil / ((rij*rjl)*(rij*rjl)); - - for (int d = 0; d < 3; d++) { - dcos_jil_di[d] = deljl[d] * inv_distjl - cos_jil_tmp * rsqjl * -delij[d]; - dcos_jil_dj[d] = (-deljl[d] + delij[d]) * inv_distjl - cos_jil_tmp * (rsqjl * delij[d] + rsqij * -deljl[d]); - dcos_jil_dk[d] = -delij[d] * inv_distjl - cos_jil_tmp * rsqij * deljl[d]; - } - - sin_jil = sin(theta_jil); - if (sin_jil >= 0 && sin_jil <= 1e-10) - tan_jil_i = cos_jil / 1e-10; - else if (sin_jil <= 0 && sin_jil >= -1e-10) - tan_jil_i = -cos_jil / 1e-10; - else tan_jil_i = cos_jil / sin_jil; - - for (int d = 0; d < 3; d ++) dellk[d] = x(k,d) - x(l,d); - const F_FLOAT rsqlk = dellk[0]*dellk[0] + dellk[1]*dellk[1] + dellk[2]*dellk[2]; - const F_FLOAT rlk = sqrt(rsqlk); + const int jtype = type(j); + + bo_ij = d_BO(i,j_index); + + delij[0] = x(j,0) - xtmp; + delij[1] = x(j,1) - ytmp; + delij[2] = x(j,2) - ztmp; + const F_FLOAT rsqij = delij[0]*delij[0] + delij[1]*delij[1] + delij[2]*delij[2]; + const F_FLOAT rij = sqrt(rsqij); + + BOA_ij = bo_ij - thb_cut; + Delta_j = d_Delta_boc[j]; + exp_tor2_ij = exp(-p_tor2 * BOA_ij); + exp_cot2_ij = exp(-p_cot2 * SQR(BOA_ij - 1.5)); + exp_tor3_DiDj = exp(-p_tor3 * (Delta_i + Delta_j)); + exp_tor4_DiDj = exp(p_tor4 * (Delta_i + Delta_j)); + exp_tor34_inv = 1.0 / (1.0 + exp_tor3_DiDj + exp_tor4_DiDj); + f11_DiDj = (2.0 + exp_tor3_DiDj) * exp_tor34_inv; + + const int ktype = type(k); + + bo_ik = d_BO(i,k_index); + + BOA_ik = bo_ik - thb_cut; + for (int d = 0; d < 3; d ++) delik[d] = x(k,d) - x(i,d); + const F_FLOAT rsqik = delik[0]*delik[0] + delik[1]*delik[1] + delik[2]*delik[2]; + const F_FLOAT rik = sqrt(rsqik); + + cos_ijk = (delij[0]*delik[0]+delij[1]*delik[1]+delij[2]*delik[2])/(rij*rik); + if (cos_ijk > 1.0) cos_ijk = 1.0; + if (cos_ijk < -1.0) cos_ijk = -1.0; + theta_ijk = acos(cos_ijk); + + // dcos_ijk + const F_FLOAT inv_dists = 1.0 / (rij * rik); + const F_FLOAT cos_ijk_tmp = cos_ijk / ((rij*rik)*(rij*rik)); + + for (int d = 0; d < 3; d++) { + dcos_ijk_di[d] = -(delik[d] + delij[d]) * inv_dists + cos_ijk_tmp * (rsqik * delij[d] + rsqij * delik[d]); + dcos_ijk_dj[d] = delik[d] * inv_dists - cos_ijk_tmp * rsqik * delij[d]; + dcos_ijk_dk[d] = delij[d] * inv_dists - cos_ijk_tmp * rsqij * delik[d]; + } + + sin_ijk = sin(theta_ijk); + if (sin_ijk >= 0 && sin_ijk <= 1e-10) + tan_ijk_i = cos_ijk / 1e-10; + else if (sin_ijk <= 0 && sin_ijk >= -1e-10) + tan_ijk_i = -cos_ijk / 1e-10; + else tan_ijk_i = cos_ijk / sin_ijk; + + exp_tor2_ik = exp(-p_tor2 * BOA_ik); + exp_cot2_ik = exp(-p_cot2 * SQR(BOA_ik -1.5)); + + const int ltype = type(l); + + bo_jl = d_BO(j,l_index); + + for (int d = 0; d < 3; d ++) deljl[d] = x(l,d) - x(j,d); + const F_FLOAT rsqjl = deljl[0]*deljl[0] + deljl[1]*deljl[1] + deljl[2]*deljl[2]; + const F_FLOAT rjl = sqrt(rsqjl); + BOA_jl = bo_jl - thb_cut; + + cos_jil = -(delij[0]*deljl[0]+delij[1]*deljl[1]+delij[2]*deljl[2])/(rij*rjl); + if (cos_jil > 1.0) cos_jil = 1.0; + if (cos_jil < -1.0) cos_jil = -1.0; + theta_jil = acos(cos_jil); + + // dcos_jil + const F_FLOAT inv_distjl = 1.0 / (rij * rjl); + const F_FLOAT cos_jil_tmp = cos_jil / ((rij*rjl)*(rij*rjl)); + + for (int d = 0; d < 3; d++) { + dcos_jil_di[d] = deljl[d] * inv_distjl - cos_jil_tmp * rsqjl * -delij[d]; + dcos_jil_dj[d] = (-deljl[d] + delij[d]) * inv_distjl - cos_jil_tmp * (rsqjl * delij[d] + rsqij * -deljl[d]); + dcos_jil_dk[d] = -delij[d] * inv_distjl - cos_jil_tmp * rsqij * deljl[d]; + } + + sin_jil = sin(theta_jil); + if (sin_jil >= 0 && sin_jil <= 1e-10) + tan_jil_i = cos_jil / 1e-10; + else if (sin_jil <= 0 && sin_jil >= -1e-10) + tan_jil_i = -cos_jil / 1e-10; + else tan_jil_i = cos_jil / sin_jil; + + for (int d = 0; d < 3; d ++) dellk[d] = x(k,d) - x(l,d); + const F_FLOAT rsqlk = dellk[0]*dellk[0] + dellk[1]*dellk[1] + dellk[2]*dellk[2]; + const F_FLOAT rlk = sqrt(rsqlk); + + F_FLOAT sin_ijk_rnd = sin_ijk; + F_FLOAT sin_jil_rnd = sin_jil; - F_FLOAT unnorm_cos_omega, unnorm_sin_omega, omega; - F_FLOAT htra, htrb, htrc, hthd, hthe, hnra, hnrc, hnhd, hnhe; - F_FLOAT arg, poem, tel; - F_FLOAT cross_ij_jl[3]; + if (sin_ijk >= 0 && sin_ijk <= 1e-10) sin_ijk_rnd = 1e-10; + else if (sin_ijk <= 0 && sin_ijk >= -1e-10) sin_ijk_rnd = -1e-10; + if (sin_jil >= 0 && sin_jil <= 1e-10) sin_jil_rnd = 1e-10; + else if (sin_jil <= 0 && sin_jil >= -1e-10) sin_jil_rnd = -1e-10; - // omega + F_FLOAT unnorm_cos_omega, unnorm_sin_omega, omega; + F_FLOAT htra, htrb, htrc, hthd, hthe, hnra, hnrc, hnhd, hnhe; + F_FLOAT arg, poem, tel; + F_FLOAT cross_ij_jl[3]; - F_FLOAT dot_ij_jk = -(delij[0]*delik[0]+delij[1]*delik[1]+delij[2]*delik[2]); - F_FLOAT dot_ij_lj = delij[0]*deljl[0]+delij[1]*deljl[1]+delij[2]*deljl[2]; - F_FLOAT dot_ik_jl = delik[0]*deljl[0]+delik[1]*deljl[1]+delik[2]*deljl[2]; - unnorm_cos_omega = dot_ij_jk * dot_ij_lj + rsqij * dot_ik_jl; + // omega - cross_ij_jl[0] = delij[1]*deljl[2] - delij[2]*deljl[1]; - cross_ij_jl[1] = delij[2]*deljl[0] - delij[0]*deljl[2]; - cross_ij_jl[2] = delij[0]*deljl[1] - delij[1]*deljl[0]; + F_FLOAT dot_ij_jk = -(delij[0]*delik[0]+delij[1]*delik[1]+delij[2]*delik[2]); + F_FLOAT dot_ij_lj = delij[0]*deljl[0]+delij[1]*deljl[1]+delij[2]*deljl[2]; + F_FLOAT dot_ik_jl = delik[0]*deljl[0]+delik[1]*deljl[1]+delik[2]*deljl[2]; + unnorm_cos_omega = dot_ij_jk * dot_ij_lj + rsqij * dot_ik_jl; - unnorm_sin_omega = -rij*(delik[0]*cross_ij_jl[0]+delik[1]*cross_ij_jl[1]+delik[2]*cross_ij_jl[2]); - omega = atan2(unnorm_sin_omega, unnorm_cos_omega); + cross_ij_jl[0] = delij[1]*deljl[2] - delij[2]*deljl[1]; + cross_ij_jl[1] = delij[2]*deljl[0] - delij[0]*deljl[2]; + cross_ij_jl[2] = delij[0]*deljl[1] - delij[1]*deljl[0]; - htra = rik + cos_ijk * (rjl * cos_jil - rij); - htrb = rij - rik * cos_ijk - rjl * cos_jil; - htrc = rjl + cos_jil * (rik * cos_ijk - rij); - hthd = rik * sin_ijk * (rij - rjl * cos_jil); - hthe = rjl * sin_jil * (rij - rik * cos_ijk); - hnra = rjl * sin_ijk * sin_jil; - hnrc = rik * sin_ijk * sin_jil; - hnhd = rik * rjl * cos_ijk * sin_jil; - hnhe = rik * rjl * sin_ijk * cos_jil; + unnorm_sin_omega = -rij*(delik[0]*cross_ij_jl[0]+delik[1]*cross_ij_jl[1]+delik[2]*cross_ij_jl[2]); + omega = atan2(unnorm_sin_omega, unnorm_cos_omega); - poem = 2.0 * rik * rjl * sin_ijk * sin_jil; - if (poem < 1e-20) poem = 1e-20; + htra = rik + cos_ijk * (rjl * cos_jil - rij); + htrb = rij - rik * cos_ijk - rjl * cos_jil; + htrc = rjl + cos_jil * (rik * cos_ijk - rij); + hthd = rik * sin_ijk_rnd * (rij - rjl * cos_jil); + hthe = rjl * sin_jil_rnd * (rij - rik * cos_ijk); + hnra = rjl * sin_ijk_rnd * sin_jil_rnd; + hnrc = rik * sin_ijk_rnd * sin_jil_rnd; + hnhd = rik * rjl * cos_ijk * sin_jil_rnd; + hnhe = rik * rjl * sin_ijk_rnd * cos_jil; - tel = SQR(rik) + SQR(rij) + SQR(rjl) - SQR(rlk) - - 2.0 * (rik * rij * cos_ijk - rik * rjl * cos_ijk * cos_jil + rij * rjl * cos_jil); + tel = SQR(rik) + SQR(rij) + SQR(rjl) - SQR(rlk) - + 2.0 * (rik * rij * cos_ijk - rik * rjl * cos_ijk * cos_jil + rij * rjl * cos_jil); - F_FLOAT inv_poem = 1.0 / poem; + poem = 2.0 * rik * rjl * sin_ijk_rnd * sin_jil_rnd; + F_FLOAT inv_poem = 1.0 / poem; - arg = tel * inv_poem; - if (arg > 1.0) arg = 1.0; - if (arg < -1.0) arg = -1.0; + arg = tel * inv_poem; + if (arg > 1.0) arg = 1.0; + if (arg < -1.0) arg = -1.0; - F_FLOAT sin_ijk_rnd = sin_ijk; - F_FLOAT sin_jil_rnd = sin_jil; + cos_omega = cos(omega); + cos2omega = cos(2. * omega); + cos3omega = cos(3. * omega); + + // torsion energy - if (sin_ijk >= 0 && sin_ijk <= 1e-10) sin_ijk_rnd = 1e-10; - else if (sin_ijk <= 0 && sin_ijk >= -1e-10) sin_ijk_rnd = -1e-10; - if (sin_jil >= 0 && sin_jil <= 1e-10) sin_jil_rnd = 1e-10; - else if (sin_jil <= 0 && sin_jil >= -1e-10) sin_jil_rnd = -1e-10; - - cos_omega = cos(omega); - cos2omega = cos(2. * omega); - cos3omega = cos(3. * omega); - - // torsion energy - - p_tor1 = paramsfbp(ktype,itype,jtype,ltype).p_tor1; - p_cot1 = paramsfbp(ktype,itype,jtype,ltype).p_cot1; - V1 = paramsfbp(ktype,itype,jtype,ltype).V1; - V2 = paramsfbp(ktype,itype,jtype,ltype).V2; - V3 = paramsfbp(ktype,itype,jtype,ltype).V3; - - exp_tor1 = exp(p_tor1 * SQR(2.0 - d_BO_pi(i,j_index) - f11_DiDj)); - exp_tor2_jl = exp(-p_tor2 * BOA_jl); - exp_cot2_jl = exp(-p_cot2 * SQR(BOA_jl - 1.5)); - fn10 = (1.0 - exp_tor2_ik) * (1.0 - exp_tor2_ij) * (1.0 - exp_tor2_jl); - - CV = 0.5 * (V1 * (1.0 + cos_omega) + V2 * exp_tor1 * (1.0 - cos2omega) + V3 * (1.0 + cos3omega)); - - e_tor = fn10 * sin_ijk * sin_jil * CV; - if (eflag) ev.ereax[6] += e_tor; - - dfn11 = (-p_tor3 * exp_tor3_DiDj + (p_tor3 * exp_tor3_DiDj - p_tor4 * exp_tor4_DiDj) * - (2.0 + exp_tor3_DiDj) * exp_tor34_inv) * exp_tor34_inv; - - CEtors1 = sin_ijk * sin_jil * CV; - - CEtors2 = -fn10 * 2.0 * p_tor1 * V2 * exp_tor1 * (2.0 - d_BO_pi(i,j_index) - f11_DiDj) * - (1.0 - SQR(cos_omega)) * sin_ijk * sin_jil; - CEtors3 = CEtors2 * dfn11; - - CEtors4 = CEtors1 * p_tor2 * exp_tor2_ik * (1.0 - exp_tor2_ij) * (1.0 - exp_tor2_jl); - CEtors5 = CEtors1 * p_tor2 * (1.0 - exp_tor2_ik) * exp_tor2_ij * (1.0 - exp_tor2_jl); - CEtors6 = CEtors1 * p_tor2 * (1.0 - exp_tor2_ik) * (1.0 - exp_tor2_ij) * exp_tor2_jl; - - cmn = -fn10 * CV; - CEtors7 = cmn * sin_jil * tan_ijk_i; - CEtors8 = cmn * sin_ijk * tan_jil_i; - - CEtors9 = fn10 * sin_ijk * sin_jil * - (0.5 * V1 - 2.0 * V2 * exp_tor1 * cos_omega + 1.5 * V3 * (cos2omega + 2.0 * SQR(cos_omega))); - - // 4-body conjugation energy - - fn12 = exp_cot2_ik * exp_cot2_ij * exp_cot2_jl; - e_con = p_cot1 * fn12 * (1.0 + (SQR(cos_omega) - 1.0) * sin_ijk * sin_jil); - if (eflag) ev.ereax[7] += e_con; - - Cconj = -2.0 * fn12 * p_cot1 * p_cot2 * (1.0 + (SQR(cos_omega) - 1.0) * sin_ijk * sin_jil); - - CEconj1 = Cconj * (BOA_ik - 1.5e0); - CEconj2 = Cconj * (BOA_ij - 1.5e0); - CEconj3 = Cconj * (BOA_jl - 1.5e0); - - CEconj4 = -p_cot1 * fn12 * (SQR(cos_omega) - 1.0) * sin_jil * tan_ijk_i; - CEconj5 = -p_cot1 * fn12 * (SQR(cos_omega) - 1.0) * sin_ijk * tan_jil_i; - CEconj6 = 2.0 * p_cot1 * fn12 * cos_omega * sin_ijk * sin_jil; - - // forces - - // contribution to bond order - - a_Cdbopi(i,j_index) += CEtors2; - - a_CdDelta[j] += CEtors3; - a_CdDelta[i] += CEtors3; - - a_Cdbo(i,k_index) += CEtors4 + CEconj1; - a_Cdbo(i,j_index) += CEtors5 + CEconj2; - a_Cdbo(j,l_index) += CEtors6 + CEconj3; // trouble - - const F_FLOAT coeff74 = CEtors7 + CEconj4; - const F_FLOAT coeff85 = CEtors8 + CEconj5; - const F_FLOAT coeff96 = CEtors9 + CEconj6; - - const F_FLOAT inv_rij = 1.0 / rij; - const F_FLOAT inv_rik = 1.0 / rik; - const F_FLOAT inv_rjl = 1.0 / rjl; - const F_FLOAT inv_sin_ijk_rnd = 1.0 / sin_ijk_rnd; - const F_FLOAT inv_sin_jil_rnd = 1.0 / sin_jil_rnd; - - #pragma unroll - for (int d = 0; d < 3; d++) { - // dcos_omega_di - F_FLOAT dcos_omega_dk = ((htra-arg*hnra) * inv_rik) * delik[d] - dellk[d]; - dcos_omega_dk += (hthd-arg*hnhd) * inv_sin_ijk_rnd * -dcos_ijk_dk[d]; - dcos_omega_dk *= 2.0 * inv_poem; - - // dcos_omega_dj - F_FLOAT dcos_omega_di = -((htra-arg*hnra) * inv_rik) * delik[d] - htrb * inv_rij * delij[d]; - dcos_omega_di += -(hthd-arg*hnhd) * inv_sin_ijk_rnd * dcos_ijk_di[d]; - dcos_omega_di += -(hthe-arg*hnhe) * inv_sin_jil_rnd * dcos_jil_di[d]; - dcos_omega_di *= 2.0 * inv_poem; - - // dcos_omega_dk - F_FLOAT dcos_omega_dj = -((htrc-arg*hnrc) * inv_rjl) * deljl[d] + htrb * inv_rij * delij[d]; - dcos_omega_dj += -(hthd-arg*hnhd) * inv_sin_ijk_rnd * dcos_ijk_dj[d]; - dcos_omega_dj += -(hthe-arg*hnhe) * inv_sin_jil_rnd * dcos_jil_dj[d]; - dcos_omega_dj *= 2.0 * inv_poem; - - // dcos_omega_dl - F_FLOAT dcos_omega_dl = ((htrc-arg*hnrc) * inv_rjl) * deljl[d] + dellk[d]; - dcos_omega_dl += (hthe-arg*hnhe) * inv_sin_jil_rnd * -dcos_jil_dk[d]; - dcos_omega_dl *= 2.0 * inv_poem; - - // dcos_theta_ijk - fi_tmp[d] = (coeff74) * dcos_ijk_di[d]; - fj_tmp[d] = (coeff74) * dcos_ijk_dj[d]; - fk_tmp[d] = (coeff74) * dcos_ijk_dk[d]; - - // dcos_theta_jil - fi_tmp[d] += (coeff85) * dcos_jil_di[d]; - fj_tmp[d] += (coeff85) * dcos_jil_dj[d]; - F_FLOAT fl_tmp = (coeff85) * dcos_jil_dk[d]; - - // dcos_omega - fi_tmp[d] += (coeff96) * dcos_omega_di; - fj_tmp[d] += (coeff96) * dcos_omega_dj; - fk_tmp[d] += (coeff96) * dcos_omega_dk; - fl_tmp += (coeff96) * dcos_omega_dl; - - // total forces - a_f(i,d) -= fi_tmp[d]; - a_f(j,d) -= fj_tmp[d]; - a_f(k,d) -= fk_tmp[d]; - a_f(l,d) -= fl_tmp; - } - - // per-atom energy/virial tally - - if (EVFLAG) { - eng_tmp = e_tor + e_con; - //if (eflag_atom) this->template ev_tally(ev,i,j,eng_tmp,0.0,0.0,0.0,0.0); - if (eflag_atom) this->template e_tally(ev,i,j,eng_tmp); - if (vflag_either) { - for (int d = 0; d < 3; d ++) delil[d] = x(l,d) - x(i,d); - for (int d = 0; d < 3; d ++) delkl[d] = x(l,d) - x(k,d); - this->template v_tally4(ev,k,i,j,l,fk_tmp,fi_tmp,fj_tmp,delkl,delil,deljl); - } - } + p_tor1 = paramsfbp(ktype,itype,jtype,ltype).p_tor1; + p_cot1 = paramsfbp(ktype,itype,jtype,ltype).p_cot1; + V1 = paramsfbp(ktype,itype,jtype,ltype).V1; + V2 = paramsfbp(ktype,itype,jtype,ltype).V2; + V3 = paramsfbp(ktype,itype,jtype,ltype).V3; + exp_tor1 = exp(p_tor1 * SQR(2.0 - d_BO_pi(i,j_index) - f11_DiDj)); + exp_tor2_jl = exp(-p_tor2 * BOA_jl); + exp_cot2_jl = exp(-p_cot2 * SQR(BOA_jl - 1.5)); + fn10 = (1.0 - exp_tor2_ik) * (1.0 - exp_tor2_ij) * (1.0 - exp_tor2_jl); + CV = 0.5 * (V1 * (1.0 + cos_omega) + V2 * exp_tor1 * (1.0 - cos2omega) + V3 * (1.0 + cos3omega)); + + e_tor = fn10 * sin_ijk * sin_jil * CV; + if (eflag) ev.ereax[6] += e_tor; + + dfn11 = (-p_tor3 * exp_tor3_DiDj + (p_tor3 * exp_tor3_DiDj - p_tor4 * exp_tor4_DiDj) * + (2.0 + exp_tor3_DiDj) * exp_tor34_inv) * exp_tor34_inv; + + CEtors1 = sin_ijk * sin_jil * CV; + + CEtors2 = -fn10 * 2.0 * p_tor1 * V2 * exp_tor1 * (2.0 - d_BO_pi(i,j_index) - f11_DiDj) * + (1.0 - SQR(cos_omega)) * sin_ijk * sin_jil; + CEtors3 = CEtors2 * dfn11; + + CEtors4 = CEtors1 * p_tor2 * exp_tor2_ik * (1.0 - exp_tor2_ij) * (1.0 - exp_tor2_jl); + CEtors5 = CEtors1 * p_tor2 * (1.0 - exp_tor2_ik) * exp_tor2_ij * (1.0 - exp_tor2_jl); + CEtors6 = CEtors1 * p_tor2 * (1.0 - exp_tor2_ik) * (1.0 - exp_tor2_ij) * exp_tor2_jl; + + cmn = -fn10 * CV; + CEtors7 = cmn * sin_jil * tan_ijk_i; + CEtors8 = cmn * sin_ijk * tan_jil_i; + + CEtors9 = fn10 * sin_ijk * sin_jil * + (0.5 * V1 - 2.0 * V2 * exp_tor1 * cos_omega + 1.5 * V3 * (cos2omega + 2.0 * SQR(cos_omega))); + + // 4-body conjugation energy + + fn12 = exp_cot2_ik * exp_cot2_ij * exp_cot2_jl; + e_con = p_cot1 * fn12 * (1.0 + (SQR(cos_omega) - 1.0) * sin_ijk * sin_jil); + if (eflag) ev.ereax[7] += e_con; + + Cconj = -2.0 * fn12 * p_cot1 * p_cot2 * (1.0 + (SQR(cos_omega) - 1.0) * sin_ijk * sin_jil); + + CEconj1 = Cconj * (BOA_ik - 1.5e0); + CEconj2 = Cconj * (BOA_ij - 1.5e0); + CEconj3 = Cconj * (BOA_jl - 1.5e0); + + CEconj4 = -p_cot1 * fn12 * (SQR(cos_omega) - 1.0) * sin_jil * tan_ijk_i; + CEconj5 = -p_cot1 * fn12 * (SQR(cos_omega) - 1.0) * sin_ijk * tan_jil_i; + CEconj6 = 2.0 * p_cot1 * fn12 * cos_omega * sin_ijk * sin_jil; + + // forces + + // contribution to bond order + + a_Cdbopi(i,j_index) += CEtors2; + + a_CdDelta[j] += CEtors3; + a_CdDelta[i] += CEtors3; + + a_Cdbo(i,k_index) += CEtors4 + CEconj1; + a_Cdbo(i,j_index) += CEtors5 + CEconj2; + a_Cdbo(j,l_index) += CEtors6 + CEconj3; + + const F_FLOAT coeff74 = CEtors7 + CEconj4; + const F_FLOAT coeff85 = CEtors8 + CEconj5; + const F_FLOAT coeff96 = CEtors9 + CEconj6; + + const F_FLOAT inv_rij = 1.0 / rij; + const F_FLOAT inv_rik = 1.0 / rik; + const F_FLOAT inv_rjl = 1.0 / rjl; + const F_FLOAT inv_sin_ijk_rnd = 1.0 / sin_ijk_rnd; + const F_FLOAT inv_sin_jil_rnd = 1.0 / sin_jil_rnd; + + #pragma unroll + for (int d = 0; d < 3; d++) { + // dcos_omega_di + F_FLOAT dcos_omega_dk = ((htra-arg*hnra) * inv_rik) * delik[d] - dellk[d]; + dcos_omega_dk += (hthd-arg*hnhd) * inv_sin_ijk_rnd * -dcos_ijk_dk[d]; + dcos_omega_dk *= 2.0 * inv_poem; + + // dcos_omega_dj + F_FLOAT dcos_omega_di = -((htra-arg*hnra) * inv_rik) * delik[d] - htrb * inv_rij * delij[d]; + dcos_omega_di += -(hthd-arg*hnhd) * inv_sin_ijk_rnd * dcos_ijk_di[d]; + dcos_omega_di += -(hthe-arg*hnhe) * inv_sin_jil_rnd * dcos_jil_di[d]; + dcos_omega_di *= 2.0 * inv_poem; + + // dcos_omega_dk + F_FLOAT dcos_omega_dj = -((htrc-arg*hnrc) * inv_rjl) * deljl[d] + htrb * inv_rij * delij[d]; + dcos_omega_dj += -(hthd-arg*hnhd) * inv_sin_ijk_rnd * dcos_ijk_dj[d]; + dcos_omega_dj += -(hthe-arg*hnhe) * inv_sin_jil_rnd * dcos_jil_dj[d]; + dcos_omega_dj *= 2.0 * inv_poem; + + // dcos_omega_dl + F_FLOAT dcos_omega_dl = ((htrc-arg*hnrc) * inv_rjl) * deljl[d] + dellk[d]; + dcos_omega_dl += (hthe-arg*hnhe) * inv_sin_jil_rnd * -dcos_jil_dk[d]; + dcos_omega_dl *= 2.0 * inv_poem; + + // dcos_theta_ijk + fi_tmp[d] = (coeff74) * dcos_ijk_di[d]; + fj_tmp[d] = (coeff74) * dcos_ijk_dj[d]; + fk_tmp[d] = (coeff74) * dcos_ijk_dk[d]; + + // dcos_theta_jil + fi_tmp[d] += (coeff85) * dcos_jil_di[d]; + fj_tmp[d] += (coeff85) * dcos_jil_dj[d]; + F_FLOAT fl_tmp = (coeff85) * dcos_jil_dk[d]; + + // dcos_omega + fi_tmp[d] += (coeff96) * dcos_omega_di; + fj_tmp[d] += (coeff96) * dcos_omega_dj; + fk_tmp[d] += (coeff96) * dcos_omega_dk; + fl_tmp += (coeff96) * dcos_omega_dl; + + // total forces + a_f(i,d) -= fi_tmp[d]; + a_f(j,d) -= fj_tmp[d]; + a_f(k,d) -= fk_tmp[d]; + a_f(l,d) -= fl_tmp; + } + + // per-atom energy/virial tally + + if (EVFLAG) { + eng_tmp = e_tor + e_con; + //if (eflag_atom) this->template ev_tally(ev,i,j,eng_tmp,0.0,0.0,0.0,0.0); + if (eflag_atom) this->template e_tally(ev,i,j,eng_tmp); + if (vflag_either) { + for (int d = 0; d < 3; d ++) delil[d] = x(l,d) - x(i,d); + for (int d = 0; d < 3; d ++) delkl[d] = x(l,d) - x(k,d); + this->template v_tally4(ev,k,i,j,l,fk_tmp,fi_tmp,fj_tmp,delkl,delil,deljl); + } + } } template diff --git a/src/REAXFF/reaxff_defs.h b/src/REAXFF/reaxff_defs.h index 45fa182728..0650c518fe 100644 --- a/src/REAXFF/reaxff_defs.h +++ b/src/REAXFF/reaxff_defs.h @@ -56,6 +56,8 @@ #define REAX_MAX_3BODY_PARAM 5 #define REAX_MAX_4BODY_PARAM 5 +#define MIN_SINE 1e-10 + namespace ReaxFF { /******************* ENUMERATORS *************************/ enum { BONDS, THREE_BODIES, HBONDS, FAR_NBRS, LIST_N }; diff --git a/src/REAXFF/reaxff_torsion_angles.cpp b/src/REAXFF/reaxff_torsion_angles.cpp index 329f7b8a7a..2b94bf50ae 100644 --- a/src/REAXFF/reaxff_torsion_angles.cpp +++ b/src/REAXFF/reaxff_torsion_angles.cpp @@ -31,8 +31,6 @@ #include -#define MIN_SINE 1e-10 - namespace ReaxFF { double Calculate_Omega(rvec dvec_ij, double r_ij, rvec dvec_jk, double r_jk, rvec dvec_kl, double r_kl, rvec dvec_li, double r_li, @@ -52,6 +50,11 @@ namespace ReaxFF { sin_jkl = sin(p_jkl->theta); cos_jkl = cos(p_jkl->theta); + if (sin_ijk >= 0 && sin_ijk <= MIN_SINE) sin_ijk = MIN_SINE; + else if (sin_ijk <= 0 && sin_ijk >= -MIN_SINE) sin_ijk = -MIN_SINE; + if (sin_jkl >= 0 && sin_jkl <= MIN_SINE) sin_jkl = MIN_SINE; + else if (sin_jkl <= 0 && sin_jkl >= -MIN_SINE) sin_jkl = -MIN_SINE; + /* omega */ unnorm_cos_omega = -rvec_Dot(dvec_ij, dvec_jk) * rvec_Dot(dvec_jk, dvec_kl) + SQR(r_jk) * rvec_Dot(dvec_ij, dvec_kl); @@ -71,22 +74,16 @@ namespace ReaxFF { hnhd = r_ij * r_kl * cos_ijk * sin_jkl; hnhe = r_ij * r_kl * sin_ijk * cos_jkl; - poem = 2.0 * r_ij * r_kl * sin_ijk * sin_jkl; - if (poem < 1e-20) poem = 1e-20; - tel = SQR(r_ij) + SQR(r_jk) + SQR(r_kl) - SQR(r_li) - 2.0 * (r_ij * r_jk * cos_ijk - r_ij * r_kl * cos_ijk * cos_jkl + r_jk * r_kl * cos_jkl); + poem = 2.0 * r_ij * r_kl * sin_ijk * sin_jkl; + arg = tel / poem; if (arg > 1.0) arg = 1.0; if (arg < -1.0) arg = -1.0; - if (sin_ijk >= 0 && sin_ijk <= MIN_SINE) sin_ijk = MIN_SINE; - else if (sin_ijk <= 0 && sin_ijk >= -MIN_SINE) sin_ijk = -MIN_SINE; - if (sin_jkl >= 0 && sin_jkl <= MIN_SINE) sin_jkl = MIN_SINE; - else if (sin_jkl <= 0 && sin_jkl >= -MIN_SINE) sin_jkl = -MIN_SINE; - // dcos_omega_di rvec_ScaledSum(dcos_omega_di, (htra-arg*hnra)/r_ij, dvec_ij, -1., dvec_li); rvec_ScaledAdd(dcos_omega_di,-(hthd-arg*hnhd)/sin_ijk, p_ijk->dcos_dk); From 234b9f180a5ff02f1c23b5b528e5c4229fde714d Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 31 May 2022 14:46:57 -0400 Subject: [PATCH 254/585] use clang-tidy and clang-format to update/modernize/simplify code --- src/COLVARS/colvarproxy_lammps.cpp | 8 +-- src/COLVARS/fix_colvars.cpp | 7 +-- src/COLVARS/ndx_group.cpp | 2 +- src/ELECTRODE/ewald_electrode.cpp | 2 +- src/ELECTRODE/pppm_electrode.cpp | 3 +- unittest/c-library/test_library_commands.cpp | 2 +- unittest/force-styles/test_angle_style.cpp | 39 ++++++++------- unittest/force-styles/test_bond_style.cpp | 38 +++++++------- unittest/force-styles/test_config_reader.cpp | 2 +- unittest/force-styles/test_dihedral_style.cpp | 27 +++++----- unittest/force-styles/test_fix_timestep.cpp | 49 ++++++++++++------- unittest/force-styles/test_improper_style.cpp | 27 +++++----- unittest/force-styles/test_pair_style.cpp | 15 +++--- unittest/formats/test_dump_atom.cpp | 15 +++--- unittest/formats/test_dump_cfg.cpp | 4 +- unittest/formats/test_dump_custom.cpp | 18 +++---- unittest/formats/test_dump_local.cpp | 4 +- unittest/formats/test_file_operations.cpp | 10 ++-- unittest/python/test_python_package.cpp | 6 +-- 19 files changed, 146 insertions(+), 132 deletions(-) diff --git a/src/COLVARS/colvarproxy_lammps.cpp b/src/COLVARS/colvarproxy_lammps.cpp index 0989460a75..eb03c14de7 100644 --- a/src/COLVARS/colvarproxy_lammps.cpp +++ b/src/COLVARS/colvarproxy_lammps.cpp @@ -117,7 +117,7 @@ void colvarproxy_lammps::init(const char *conf_file) if (_lmp->update->ntimestep != 0) { cvm::log("Setting initial step number from LAMMPS: "+ cvm::to_str(_lmp->update->ntimestep)+"\n"); - colvars->it = colvars->it_restart = + colvarmodule::it = colvarmodule::it_restart = static_cast(_lmp->update->ntimestep); } @@ -174,7 +174,7 @@ double colvarproxy_lammps::compute() } else { // Use the time step number from LAMMPS Update object if (_lmp->update->ntimestep - previous_step == 1) { - colvars->it++; + colvarmodule::it++; b_simulation_continuing = false; } else { // Cases covered by this condition: @@ -209,7 +209,7 @@ double colvarproxy_lammps::compute() if (cvm::debug()) { cvm::log(std::string(cvm::line_marker)+ - "colvarproxy_lammps, step no. "+cvm::to_str(colvars->it)+"\n"+ + "colvarproxy_lammps, step no. "+cvm::to_str(colvarmodule::it)+"\n"+ "Updating internal data.\n"); } @@ -269,7 +269,7 @@ cvm::rvector colvarproxy_lammps::position_distance(cvm::atom_pos const &pos1, double ytmp = pos2.y - pos1.y; double ztmp = pos2.z - pos1.z; _lmp->domain->minimum_image(xtmp,ytmp,ztmp); - return cvm::rvector(xtmp, ytmp, ztmp); + return {xtmp, ytmp, ztmp}; } diff --git a/src/COLVARS/fix_colvars.cpp b/src/COLVARS/fix_colvars.cpp index 02bf8d4347..a46e6318d0 100644 --- a/src/COLVARS/fix_colvars.cpp +++ b/src/COLVARS/fix_colvars.cpp @@ -135,8 +135,6 @@ static void rebuild_table_int(inthash_t *tptr) { /* free memory used by old table */ free(old_bucket); - - return; } /* @@ -166,8 +164,6 @@ void inthash_init(inthash_t *tptr, int buckets) { /* allocate memory for table */ tptr->bucket=(inthash_node_t **) calloc(tptr->size, sizeof(inthash_node_t *)); - - return; } /* @@ -847,7 +843,6 @@ void FixColvars::post_force_respa(int vflag, int ilevel, int /*iloop*/) { /* only process colvar forces on the outmost RESPA level. */ if (ilevel == nlevels_respa-1) post_force(vflag); - return; } /* ---------------------------------------------------------------------- */ @@ -939,7 +934,7 @@ void FixColvars::end_of_step() void FixColvars::write_restart(FILE *fp) { if (me == 0) { - std::string rest_text(""); + std::string rest_text; proxy->serialize_status(rest_text); // TODO call write_output_files() const char *cvm_state = rest_text.c_str(); diff --git a/src/COLVARS/ndx_group.cpp b/src/COLVARS/ndx_group.cpp index 9560c41c6a..34b3bd7dae 100644 --- a/src/COLVARS/ndx_group.cpp +++ b/src/COLVARS/ndx_group.cpp @@ -76,7 +76,7 @@ void Ndx2Group::command(int narg, char **arg) int len; bigint num; FILE *fp; - std::string name = "", next; + std::string name, next; if (narg < 1) error->all(FLERR,"Illegal ndx2group command"); if (atom->tag_enable == 0) diff --git a/src/ELECTRODE/ewald_electrode.cpp b/src/ELECTRODE/ewald_electrode.cpp index d84ef317ff..4e47d955ef 100644 --- a/src/ELECTRODE/ewald_electrode.cpp +++ b/src/ELECTRODE/ewald_electrode.cpp @@ -40,7 +40,7 @@ using namespace MathConst; /* ---------------------------------------------------------------------- */ -EwaldElectrode::EwaldElectrode(LAMMPS *lmp) : Ewald(lmp), ElectrodeKSpace() +EwaldElectrode::EwaldElectrode(LAMMPS *lmp) : Ewald(lmp) { eikr_step = -1; } diff --git a/src/ELECTRODE/pppm_electrode.cpp b/src/ELECTRODE/pppm_electrode.cpp index 9733c47b14..91d6acc2d5 100644 --- a/src/ELECTRODE/pppm_electrode.cpp +++ b/src/ELECTRODE/pppm_electrode.cpp @@ -65,8 +65,7 @@ enum { FORWARD_IK, FORWARD_AD, FORWARD_IK_PERATOM, FORWARD_AD_PERATOM }; /* ---------------------------------------------------------------------- */ PPPMElectrode::PPPMElectrode(LAMMPS *lmp) : - PPPM(lmp), ElectrodeKSpace(), electrolyte_density_brick(nullptr), - electrolyte_density_fft(nullptr) + PPPM(lmp), electrolyte_density_brick(nullptr), electrolyte_density_fft(nullptr) { group_group_enable = 0; electrolyte_density_brick = nullptr; diff --git a/unittest/c-library/test_library_commands.cpp b/unittest/c-library/test_library_commands.cpp index f1cc51d8d9..d4e326cd36 100644 --- a/unittest/c-library/test_library_commands.cpp +++ b/unittest/c-library/test_library_commands.cpp @@ -104,7 +104,7 @@ TEST_F(LibraryCommands, from_list) TEST_F(LibraryCommands, from_string) { - std::string cmds(""); + std::string cmds; for (auto &inp : demo_input) { cmds += inp; diff --git a/unittest/force-styles/test_angle_style.cpp b/unittest/force-styles/test_angle_style.cpp index a617ec1783..82a4731492 100644 --- a/unittest/force-styles/test_angle_style.cpp +++ b/unittest/force-styles/test_angle_style.cpp @@ -32,8 +32,8 @@ #include "input.h" #include "lammps.h" #include "modify.h" -#include "universe.h" #include "platform.h" +#include "universe.h" #include #include @@ -90,7 +90,7 @@ LAMMPS *init_lammps(int argc, char **argv, const TestConfig &cfg, const bool new // utility lambdas to improve readability auto command = [&](const std::string &line) { - lmp->input->one(line.c_str()); + lmp->input->one(line); }; auto parse_input_script = [&](const std::string &filename) { lmp->input->file(filename.c_str()); @@ -133,7 +133,7 @@ void run_lammps(LAMMPS *lmp) { // utility lambda to improve readability auto command = [&](const std::string &line) { - lmp->input->one(line.c_str()); + lmp->input->one(line); }; command("fix 1 all nve"); @@ -148,7 +148,7 @@ void restart_lammps(LAMMPS *lmp, const TestConfig &cfg) { // utility lambda to improve readability auto command = [&](const std::string &line) { - lmp->input->one(line.c_str()); + lmp->input->one(line); }; command("clear"); @@ -175,7 +175,7 @@ void data_lammps(LAMMPS *lmp, const TestConfig &cfg) { // utility lambdas to improve readability auto command = [&](const std::string &line) { - lmp->input->one(line.c_str()); + lmp->input->one(line); }; auto parse_input_script = [&](const std::string &filename) { lmp->input->file(filename.c_str()); @@ -226,7 +226,7 @@ void generate_yaml_file(const char *outfile, const TestConfig &config) } const int natoms = lmp->atom->natoms; - std::string block(""); + std::string block; YamlWriter writer(outfile); @@ -285,7 +285,7 @@ void generate_yaml_file(const char *outfile, const TestConfig &config) // run_stress stress = lmp->force->angle->virial; block = fmt::format("{:23.16e} {:23.16e} {:23.16e} {:23.16e} {:23.16e} {:23.16e}", stress[0], - stress[1], stress[2], stress[3], stress[4], stress[5]); + stress[1], stress[2], stress[3], stress[4], stress[5]); writer.emit_block("run_stress", block); block.clear(); @@ -297,10 +297,8 @@ void generate_yaml_file(const char *outfile, const TestConfig &config) writer.emit_block("run_forces", block); cleanup_lammps(lmp, config); - return; } - TEST(AngleStyle, plain) { if (test_config.skip_tests.count(test_info_->name())) GTEST_SKIP(); @@ -335,7 +333,7 @@ TEST(AngleStyle, plain) double epsilon = test_config.epsilon; ErrorStats stats; - auto angle = lmp->force->angle; + auto angle = lmp->force->angle; EXPECT_FORCES("init_forces (newton on)", lmp->atom, test_config.init_forces, epsilon); EXPECT_STRESS("init_stress (newton on)", angle->virial, test_config.init_stress, epsilon); @@ -365,10 +363,11 @@ TEST(AngleStyle, plain) // skip over these tests if newton bond is forced to be on if (lmp->force->newton_bond == 0) { - angle = lmp->force->angle; + angle = lmp->force->angle; EXPECT_FORCES("init_forces (newton off)", lmp->atom, test_config.init_forces, epsilon); - EXPECT_STRESS("init_stress (newton off)", angle->virial, test_config.init_stress, 2*epsilon); + EXPECT_STRESS("init_stress (newton off)", angle->virial, test_config.init_stress, + 2 * epsilon); stats.reset(); EXPECT_FP_LE_WITH_EPS(angle->energy, test_config.init_energy, epsilon); @@ -393,7 +392,7 @@ TEST(AngleStyle, plain) restart_lammps(lmp, test_config); if (!verbose) ::testing::internal::GetCapturedStdout(); - angle = lmp->force->angle; + angle = lmp->force->angle; EXPECT_FORCES("restart_forces", lmp->atom, test_config.init_forces, epsilon); EXPECT_STRESS("restart_stress", angle->virial, test_config.init_stress, epsilon); @@ -405,7 +404,7 @@ TEST(AngleStyle, plain) data_lammps(lmp, test_config); if (!verbose) ::testing::internal::GetCapturedStdout(); - angle = lmp->force->angle; + angle = lmp->force->angle; EXPECT_FORCES("data_forces", lmp->atom, test_config.init_forces, epsilon); EXPECT_STRESS("data_stress", angle->virial, test_config.init_stress, epsilon); @@ -455,7 +454,7 @@ TEST(AngleStyle, omp) double epsilon = 5.0 * test_config.epsilon; ErrorStats stats; - auto angle = lmp->force->angle; + auto angle = lmp->force->angle; EXPECT_FORCES("init_forces (newton on)", lmp->atom, test_config.init_forces, epsilon); EXPECT_STRESS("init_stress (newton on)", angle->virial, test_config.init_stress, 10 * epsilon); @@ -488,10 +487,11 @@ TEST(AngleStyle, omp) // skip over these tests if newton bond is forced to be on if (lmp->force->newton_bond == 0) { - angle = lmp->force->angle; + angle = lmp->force->angle; EXPECT_FORCES("init_forces (newton off)", lmp->atom, test_config.init_forces, epsilon); - EXPECT_STRESS("init_stress (newton off)", angle->virial, test_config.init_stress, 10 * epsilon); + EXPECT_STRESS("init_stress (newton off)", angle->virial, test_config.init_stress, + 10 * epsilon); stats.reset(); EXPECT_FP_LE_WITH_EPS(angle->energy, test_config.init_energy, epsilon); @@ -502,7 +502,8 @@ TEST(AngleStyle, omp) if (!verbose) ::testing::internal::GetCapturedStdout(); EXPECT_FORCES("run_forces (newton off)", lmp->atom, test_config.run_forces, 10 * epsilon); - EXPECT_STRESS("run_stress (newton off)", angle->virial, test_config.run_stress, 10 * epsilon); + EXPECT_STRESS("run_stress (newton off)", angle->virial, test_config.run_stress, + 10 * epsilon); stats.reset(); id = lmp->modify->find_compute("sum"); @@ -556,7 +557,7 @@ TEST(AngleStyle, single) // utility lambda to improve readability auto command = [&](const std::string &line) { - lmp->input->one(line.c_str()); + lmp->input->one(line); }; // now start over diff --git a/unittest/force-styles/test_bond_style.cpp b/unittest/force-styles/test_bond_style.cpp index a851f4341f..d0d8f26b6e 100644 --- a/unittest/force-styles/test_bond_style.cpp +++ b/unittest/force-styles/test_bond_style.cpp @@ -32,8 +32,8 @@ #include "input.h" #include "lammps.h" #include "modify.h" -#include "universe.h" #include "platform.h" +#include "universe.h" #include #include @@ -90,7 +90,7 @@ LAMMPS *init_lammps(int argc, char **argv, const TestConfig &cfg, const bool new // utility lambdas to improve readability auto command = [&](const std::string &line) { - lmp->input->one(line.c_str()); + lmp->input->one(line); }; auto parse_input_script = [&](const std::string &filename) { lmp->input->file(filename.c_str()); @@ -133,7 +133,7 @@ void run_lammps(LAMMPS *lmp) { // utility lambda to improve readability auto command = [&](const std::string &line) { - lmp->input->one(line.c_str()); + lmp->input->one(line); }; command("fix 1 all nve"); @@ -148,7 +148,7 @@ void restart_lammps(LAMMPS *lmp, const TestConfig &cfg) { // utility lambda to improve readability auto command = [&](const std::string &line) { - lmp->input->one(line.c_str()); + lmp->input->one(line); }; command("clear"); @@ -175,7 +175,7 @@ void data_lammps(LAMMPS *lmp, const TestConfig &cfg) { // utility lambdas to improve readability auto command = [&](const std::string &line) { - lmp->input->one(line.c_str()); + lmp->input->one(line); }; auto parse_input_script = [&](const std::string &filename) { lmp->input->file(filename.c_str()); @@ -226,7 +226,7 @@ void generate_yaml_file(const char *outfile, const TestConfig &config) } const int natoms = lmp->atom->natoms; - std::string block(""); + std::string block; YamlWriter writer(outfile); @@ -285,7 +285,7 @@ void generate_yaml_file(const char *outfile, const TestConfig &config) // run_stress stress = lmp->force->bond->virial; block = fmt::format("{:23.16e} {:23.16e} {:23.16e} {:23.16e} {:23.16e} {:23.16e}", stress[0], - stress[1], stress[2], stress[3], stress[4], stress[5]); + stress[1], stress[2], stress[3], stress[4], stress[5]); writer.emit_block("run_stress", block); block.clear(); @@ -297,7 +297,6 @@ void generate_yaml_file(const char *outfile, const TestConfig &config) writer.emit_block("run_forces", block); cleanup_lammps(lmp, config); - return; } TEST(BondStyle, plain) @@ -334,7 +333,7 @@ TEST(BondStyle, plain) double epsilon = test_config.epsilon; ErrorStats stats; - auto bond = lmp->force->bond; + auto bond = lmp->force->bond; EXPECT_FORCES("init_forces (newton on)", lmp->atom, test_config.init_forces, epsilon); EXPECT_STRESS("init_stress (newton on)", bond->virial, test_config.init_stress, epsilon); @@ -364,10 +363,11 @@ TEST(BondStyle, plain) // skip over these tests if newton bond is forced to be on if (lmp->force->newton_bond == 0) { - bond = lmp->force->bond; + bond = lmp->force->bond; EXPECT_FORCES("init_forces (newton off)", lmp->atom, test_config.init_forces, epsilon); - EXPECT_STRESS("init_stress (newton off)", bond->virial, test_config.init_stress, 2 * epsilon); + EXPECT_STRESS("init_stress (newton off)", bond->virial, test_config.init_stress, + 2 * epsilon); stats.reset(); EXPECT_FP_LE_WITH_EPS(bond->energy, test_config.init_energy, epsilon); @@ -392,7 +392,7 @@ TEST(BondStyle, plain) restart_lammps(lmp, test_config); if (!verbose) ::testing::internal::GetCapturedStdout(); - bond = lmp->force->bond; + bond = lmp->force->bond; EXPECT_FORCES("restart_forces", lmp->atom, test_config.init_forces, epsilon); EXPECT_STRESS("restart_stress", bond->virial, test_config.init_stress, epsilon); @@ -405,7 +405,7 @@ TEST(BondStyle, plain) data_lammps(lmp, test_config); if (!verbose) ::testing::internal::GetCapturedStdout(); - bond = lmp->force->bond; + bond = lmp->force->bond; EXPECT_FORCES("data_forces", lmp->atom, test_config.init_forces, epsilon); EXPECT_STRESS("data_stress", bond->virial, test_config.init_stress, epsilon); @@ -456,7 +456,7 @@ TEST(BondStyle, omp) double epsilon = 5.0 * test_config.epsilon; ErrorStats stats; - auto bond = lmp->force->bond; + auto bond = lmp->force->bond; EXPECT_FORCES("init_forces (newton on)", lmp->atom, test_config.init_forces, epsilon); EXPECT_STRESS("init_stress (newton on)", bond->virial, test_config.init_stress, 10 * epsilon); @@ -489,10 +489,11 @@ TEST(BondStyle, omp) // skip over these tests if newton bond is forced to be on if (lmp->force->newton_bond == 0) { - bond = lmp->force->bond; + bond = lmp->force->bond; EXPECT_FORCES("init_forces (newton off)", lmp->atom, test_config.init_forces, epsilon); - EXPECT_STRESS("init_stress (newton off)", bond->virial, test_config.init_stress, 10 * epsilon); + EXPECT_STRESS("init_stress (newton off)", bond->virial, test_config.init_stress, + 10 * epsilon); stats.reset(); EXPECT_FP_LE_WITH_EPS(bond->energy, test_config.init_energy, epsilon); @@ -503,7 +504,8 @@ TEST(BondStyle, omp) if (!verbose) ::testing::internal::GetCapturedStdout(); EXPECT_FORCES("run_forces (newton off)", lmp->atom, test_config.run_forces, 10 * epsilon); - EXPECT_STRESS("run_stress (newton off)", bond->virial, test_config.run_stress, 10 * epsilon); + EXPECT_STRESS("run_stress (newton off)", bond->virial, test_config.run_stress, + 10 * epsilon); stats.reset(); id = lmp->modify->find_compute("sum"); @@ -557,7 +559,7 @@ TEST(BondStyle, single) // utility lambda to improve readability auto command = [&](const std::string &line) { - lmp->input->one(line.c_str()); + lmp->input->one(line); }; // now start over diff --git a/unittest/force-styles/test_config_reader.cpp b/unittest/force-styles/test_config_reader.cpp index d152b4fcf4..d920128862 100644 --- a/unittest/force-styles/test_config_reader.cpp +++ b/unittest/force-styles/test_config_reader.cpp @@ -29,7 +29,7 @@ using LAMMPS_NS::utils::split_words; using LAMMPS_NS::utils::trim; -TestConfigReader::TestConfigReader(TestConfig &config) : YamlReader(), config(config) +TestConfigReader::TestConfigReader(TestConfig &config) : config(config) { consumers["lammps_version"] = &TestConfigReader::lammps_version; consumers["tags"] = &TestConfigReader::tags; diff --git a/unittest/force-styles/test_dihedral_style.cpp b/unittest/force-styles/test_dihedral_style.cpp index 0156e8e021..3f3e1248e8 100644 --- a/unittest/force-styles/test_dihedral_style.cpp +++ b/unittest/force-styles/test_dihedral_style.cpp @@ -32,8 +32,8 @@ #include "input.h" #include "lammps.h" #include "modify.h" -#include "universe.h" #include "platform.h" +#include "universe.h" #include #include @@ -90,7 +90,7 @@ LAMMPS *init_lammps(int argc, char **argv, const TestConfig &cfg, const bool new // utility lambdas to improve readability auto command = [&](const std::string &line) { - lmp->input->one(line.c_str()); + lmp->input->one(line); }; auto parse_input_script = [&](const std::string &filename) { lmp->input->file(filename.c_str()); @@ -133,7 +133,7 @@ void run_lammps(LAMMPS *lmp) { // utility lambda to improve readability auto command = [&](const std::string &line) { - lmp->input->one(line.c_str()); + lmp->input->one(line); }; command("fix 1 all nve"); @@ -148,7 +148,7 @@ void restart_lammps(LAMMPS *lmp, const TestConfig &cfg) { // utility lambda to improve readability auto command = [&](const std::string &line) { - lmp->input->one(line.c_str()); + lmp->input->one(line); }; command("clear"); @@ -175,7 +175,7 @@ void data_lammps(LAMMPS *lmp, const TestConfig &cfg) { // utility lambdas to improve readability auto command = [&](const std::string &line) { - lmp->input->one(line.c_str()); + lmp->input->one(line); }; auto parse_input_script = [&](const std::string &filename) { lmp->input->file(filename.c_str()); @@ -235,7 +235,7 @@ void generate_yaml_file(const char *outfile, const TestConfig &config) } const int natoms = lmp->atom->natoms; - std::string block(""); + std::string block; YamlWriter writer(outfile); @@ -288,7 +288,7 @@ void generate_yaml_file(const char *outfile, const TestConfig &config) // run_stress stress = lmp->force->dihedral->virial; block = fmt::format("{:23.16e} {:23.16e} {:23.16e} {:23.16e} {:23.16e} {:23.16e}", stress[0], - stress[1], stress[2], stress[3], stress[4], stress[5]); + stress[1], stress[2], stress[3], stress[4], stress[5]); writer.emit_block("run_stress", block); block.clear(); @@ -300,7 +300,6 @@ void generate_yaml_file(const char *outfile, const TestConfig &config) writer.emit_block("run_forces", block); cleanup_lammps(lmp, config); - return; } TEST(DihedralStyle, plain) @@ -370,7 +369,8 @@ TEST(DihedralStyle, plain) dihedral = lmp->force->dihedral; EXPECT_FORCES("init_forces (newton off)", lmp->atom, test_config.init_forces, epsilon); - EXPECT_STRESS("init_stress (newton off)", dihedral->virial, test_config.init_stress, epsilon); + EXPECT_STRESS("init_stress (newton off)", dihedral->virial, test_config.init_stress, + epsilon); stats.reset(); EXPECT_FP_LE_WITH_EPS(dihedral->energy, test_config.init_energy, epsilon); @@ -462,7 +462,8 @@ TEST(DihedralStyle, omp) auto dihedral = lmp->force->dihedral; EXPECT_FORCES("init_forces (newton on)", lmp->atom, test_config.init_forces, epsilon); - EXPECT_STRESS("init_stress (newton on)", dihedral->virial, test_config.init_stress, 10 * epsilon); + EXPECT_STRESS("init_stress (newton on)", dihedral->virial, test_config.init_stress, + 10 * epsilon); stats.reset(); EXPECT_FP_LE_WITH_EPS(dihedral->energy, test_config.init_energy, epsilon); @@ -495,7 +496,8 @@ TEST(DihedralStyle, omp) dihedral = lmp->force->dihedral; EXPECT_FORCES("init_forces (newton off)", lmp->atom, test_config.init_forces, epsilon); - EXPECT_STRESS("init_stress (newton off)", dihedral->virial, test_config.init_stress, 10 * epsilon); + EXPECT_STRESS("init_stress (newton off)", dihedral->virial, test_config.init_stress, + 10 * epsilon); stats.reset(); EXPECT_FP_LE_WITH_EPS(dihedral->energy, test_config.init_energy, epsilon); @@ -506,7 +508,8 @@ TEST(DihedralStyle, omp) if (!verbose) ::testing::internal::GetCapturedStdout(); EXPECT_FORCES("run_forces (newton off)", lmp->atom, test_config.run_forces, 10 * epsilon); - EXPECT_STRESS("run_stress (newton off)", dihedral->virial, test_config.run_stress, 10 * epsilon); + EXPECT_STRESS("run_stress (newton off)", dihedral->virial, test_config.run_stress, + 10 * epsilon); stats.reset(); id = lmp->modify->find_compute("sum"); diff --git a/unittest/force-styles/test_fix_timestep.cpp b/unittest/force-styles/test_fix_timestep.cpp index fcf6be39d3..64aa54e96b 100644 --- a/unittest/force-styles/test_fix_timestep.cpp +++ b/unittest/force-styles/test_fix_timestep.cpp @@ -34,10 +34,10 @@ #include "lammps.h" #include "modify.h" #include "pair.h" +#include "platform.h" #include "universe.h" #include "utils.h" #include "variable.h" -#include "platform.h" #include #include @@ -92,7 +92,7 @@ LAMMPS *init_lammps(int argc, char **argv, const TestConfig &cfg, const bool use // utility lambda to improve readability auto command = [&](const std::string &line) { - lmp->input->one(line.c_str()); + lmp->input->one(line); }; command("variable input_dir index " + INPUT_FOLDER); @@ -143,7 +143,7 @@ void restart_lammps(LAMMPS *lmp, const TestConfig &cfg, bool use_rmass, bool use { // utility lambda to improve readability auto command = [&](const std::string &line) { - lmp->input->one(line.c_str()); + lmp->input->one(line); }; command("clear"); @@ -184,7 +184,7 @@ void generate_yaml_file(const char *outfile, const TestConfig &config) } const int natoms = lmp->atom->natoms; - std::string block(""); + std::string block; YamlWriter writer(outfile); // write yaml header @@ -204,8 +204,8 @@ void generate_yaml_file(const char *outfile, const TestConfig &config) if (fix->thermo_virial) { auto stress = fix->virial; block = fmt::format("{:23.16e} {:23.16e} {:23.16e} " - "{:23.16e} {:23.16e} {:23.16e}", - stress[0], stress[1], stress[2], stress[3], stress[4], stress[5]); + "{:23.16e} {:23.16e} {:23.16e}", + stress[0], stress[1], stress[2], stress[3], stress[4], stress[5]); writer.emit_block("run_stress", block); } @@ -243,7 +243,6 @@ void generate_yaml_file(const char *outfile, const TestConfig &config) } writer.emit_block("run_vel", block); cleanup_lammps(lmp, config); - return; } TEST(FixTimestep, plain) @@ -293,7 +292,8 @@ TEST(FixTimestep, plain) } else { Fix *fix = lmp->modify->fix[ifix]; if (fix->thermo_virial) { - EXPECT_STRESS("run_stress (normal run, verlet)", fix->virial, test_config.run_stress, epsilon); + EXPECT_STRESS("run_stress (normal run, verlet)", fix->virial, test_config.run_stress, + epsilon); } stats.reset(); @@ -342,7 +342,8 @@ TEST(FixTimestep, plain) } else { Fix *fix = lmp->modify->fix[ifix]; if (fix->thermo_virial) { - EXPECT_STRESS("run_stress (restart, verlet)", fix->virial, test_config.run_stress, epsilon); + EXPECT_STRESS("run_stress (restart, verlet)", fix->virial, test_config.run_stress, + epsilon); } stats.reset(); @@ -380,7 +381,8 @@ TEST(FixTimestep, plain) } else { Fix *fix = lmp->modify->fix[ifix]; if (fix->thermo_virial) { - EXPECT_STRESS("run_stress (rmass, verlet)", fix->virial, test_config.run_stress, epsilon); + EXPECT_STRESS("run_stress (rmass, verlet)", fix->virial, test_config.run_stress, + epsilon); } stats.reset(); @@ -432,7 +434,8 @@ TEST(FixTimestep, plain) } else { Fix *fix = lmp->modify->fix[ifix]; if (fix->thermo_virial) { - EXPECT_STRESS("run_stress (normal run, respa)", fix->virial, test_config.run_stress, 1000 * epsilon); + EXPECT_STRESS("run_stress (normal run, respa)", fix->virial, test_config.run_stress, + 1000 * epsilon); } stats.reset(); @@ -469,7 +472,8 @@ TEST(FixTimestep, plain) } else { Fix *fix = lmp->modify->fix[ifix]; if (fix->thermo_virial) { - EXPECT_STRESS("run_stress (restart, respa)", fix->virial, test_config.run_stress, 1000 * epsilon); + EXPECT_STRESS("run_stress (restart, respa)", fix->virial, test_config.run_stress, + 1000 * epsilon); } stats.reset(); @@ -507,7 +511,8 @@ TEST(FixTimestep, plain) } else { Fix *fix = lmp->modify->fix[ifix]; if (fix->thermo_virial) { - EXPECT_STRESS("run_stress (rmass, respa)", fix->virial, test_config.run_stress, 1000 * epsilon); + EXPECT_STRESS("run_stress (rmass, respa)", fix->virial, test_config.run_stress, + 1000 * epsilon); } stats.reset(); @@ -587,7 +592,8 @@ TEST(FixTimestep, omp) } else { Fix *fix = lmp->modify->fix[ifix]; if (fix->thermo_virial) { - EXPECT_STRESS("run_stress (normal run, verlet)", fix->virial, test_config.run_stress, epsilon); + EXPECT_STRESS("run_stress (normal run, verlet)", fix->virial, test_config.run_stress, + epsilon); } stats.reset(); @@ -636,7 +642,8 @@ TEST(FixTimestep, omp) } else { Fix *fix = lmp->modify->fix[ifix]; if (fix->thermo_virial) { - EXPECT_STRESS("run_stress (restart, verlet)", fix->virial, test_config.run_stress, epsilon); + EXPECT_STRESS("run_stress (restart, verlet)", fix->virial, test_config.run_stress, + epsilon); } stats.reset(); @@ -674,7 +681,8 @@ TEST(FixTimestep, omp) } else { Fix *fix = lmp->modify->fix[ifix]; if (fix->thermo_virial) { - EXPECT_STRESS("run_stress (rmass, verlet)", fix->virial, test_config.run_stress, epsilon); + EXPECT_STRESS("run_stress (rmass, verlet)", fix->virial, test_config.run_stress, + epsilon); } stats.reset(); @@ -725,7 +733,8 @@ TEST(FixTimestep, omp) } else { Fix *fix = lmp->modify->fix[ifix]; if (fix->thermo_virial) { - EXPECT_STRESS("run_stress (normal run, respa)", fix->virial, test_config.run_stress, 1000 * epsilon); + EXPECT_STRESS("run_stress (normal run, respa)", fix->virial, test_config.run_stress, + 1000 * epsilon); } stats.reset(); @@ -762,7 +771,8 @@ TEST(FixTimestep, omp) } else { Fix *fix = lmp->modify->fix[ifix]; if (fix->thermo_virial) { - EXPECT_STRESS("run_stress (restart, respa)", fix->virial, test_config.run_stress, 1000 * epsilon); + EXPECT_STRESS("run_stress (restart, respa)", fix->virial, test_config.run_stress, + 1000 * epsilon); } stats.reset(); @@ -800,7 +810,8 @@ TEST(FixTimestep, omp) } else { Fix *fix = lmp->modify->fix[ifix]; if (fix->thermo_virial) { - EXPECT_STRESS("run_stress (rmass, respa)", fix->virial, test_config.run_stress, 1000 * epsilon); + EXPECT_STRESS("run_stress (rmass, respa)", fix->virial, test_config.run_stress, + 1000 * epsilon); } stats.reset(); diff --git a/unittest/force-styles/test_improper_style.cpp b/unittest/force-styles/test_improper_style.cpp index 49b7d22cad..3d2719f7d0 100644 --- a/unittest/force-styles/test_improper_style.cpp +++ b/unittest/force-styles/test_improper_style.cpp @@ -32,8 +32,8 @@ #include "input.h" #include "lammps.h" #include "modify.h" -#include "universe.h" #include "platform.h" +#include "universe.h" #include #include @@ -90,7 +90,7 @@ LAMMPS *init_lammps(int argc, char **argv, const TestConfig &cfg, const bool new // utility lambdas to improve readability auto command = [&](const std::string &line) { - lmp->input->one(line.c_str()); + lmp->input->one(line); }; auto parse_input_script = [&](const std::string &filename) { lmp->input->file(filename.c_str()); @@ -133,7 +133,7 @@ void run_lammps(LAMMPS *lmp) { // utility lambda to improve readability auto command = [&](const std::string &line) { - lmp->input->one(line.c_str()); + lmp->input->one(line); }; command("fix 1 all nve"); @@ -148,7 +148,7 @@ void restart_lammps(LAMMPS *lmp, const TestConfig &cfg) { // utility lambda to improve readability auto command = [&](const std::string &line) { - lmp->input->one(line.c_str()); + lmp->input->one(line); }; command("clear"); @@ -175,7 +175,7 @@ void data_lammps(LAMMPS *lmp, const TestConfig &cfg) { // utility lambdas to improve readability auto command = [&](const std::string &line) { - lmp->input->one(line.c_str()); + lmp->input->one(line); }; auto parse_input_script = [&](const std::string &filename) { lmp->input->file(filename.c_str()); @@ -226,7 +226,7 @@ void generate_yaml_file(const char *outfile, const TestConfig &config) } const int natoms = lmp->atom->natoms; - std::string block(""); + std::string block; YamlWriter writer(outfile); @@ -279,7 +279,7 @@ void generate_yaml_file(const char *outfile, const TestConfig &config) // run_stress stress = lmp->force->improper->virial; block = fmt::format("{:23.16e} {:23.16e} {:23.16e} {:23.16e} {:23.16e} {:23.16e}", stress[0], - stress[1], stress[2], stress[3], stress[4], stress[5]); + stress[1], stress[2], stress[3], stress[4], stress[5]); writer.emit_block("run_stress", block); block.clear(); @@ -291,7 +291,6 @@ void generate_yaml_file(const char *outfile, const TestConfig &config) writer.emit_block("run_forces", block); cleanup_lammps(lmp, config); - return; } TEST(ImproperStyle, plain) @@ -361,7 +360,8 @@ TEST(ImproperStyle, plain) improper = lmp->force->improper; EXPECT_FORCES("init_forces (newton off)", lmp->atom, test_config.init_forces, epsilon); - EXPECT_STRESS("init_stress (newton off)", improper->virial, test_config.init_stress, 2 * epsilon); + EXPECT_STRESS("init_stress (newton off)", improper->virial, test_config.init_stress, + 2 * epsilon); stats.reset(); EXPECT_FP_LE_WITH_EPS(improper->energy, test_config.init_energy, epsilon); @@ -453,7 +453,8 @@ TEST(ImproperStyle, omp) auto improper = lmp->force->improper; EXPECT_FORCES("init_forces (newton on)", lmp->atom, test_config.init_forces, epsilon); - EXPECT_STRESS("init_stress (newton on)", improper->virial, test_config.init_stress, 10 * epsilon); + EXPECT_STRESS("init_stress (newton on)", improper->virial, test_config.init_stress, + 10 * epsilon); stats.reset(); EXPECT_FP_LE_WITH_EPS(improper->energy, test_config.init_energy, epsilon); @@ -486,7 +487,8 @@ TEST(ImproperStyle, omp) improper = lmp->force->improper; EXPECT_FORCES("init_forces (newton off)", lmp->atom, test_config.init_forces, epsilon); - EXPECT_STRESS("init_stress (newton off)", improper->virial, test_config.init_stress, 10 * epsilon); + EXPECT_STRESS("init_stress (newton off)", improper->virial, test_config.init_stress, + 10 * epsilon); stats.reset(); EXPECT_FP_LE_WITH_EPS(improper->energy, test_config.init_energy, epsilon); @@ -497,7 +499,8 @@ TEST(ImproperStyle, omp) if (!verbose) ::testing::internal::GetCapturedStdout(); EXPECT_FORCES("run_forces (newton off)", lmp->atom, test_config.run_forces, 10 * epsilon); - EXPECT_STRESS("run_stress (newton off)", improper->virial, test_config.run_stress, 10 * epsilon); + EXPECT_STRESS("run_stress (newton off)", improper->virial, test_config.run_stress, + 10 * epsilon); stats.reset(); id = lmp->modify->find_compute("sum"); diff --git a/unittest/force-styles/test_pair_style.cpp b/unittest/force-styles/test_pair_style.cpp index 0c8dc16c77..e56a5bba1c 100644 --- a/unittest/force-styles/test_pair_style.cpp +++ b/unittest/force-styles/test_pair_style.cpp @@ -91,7 +91,7 @@ LAMMPS *init_lammps(int argc, char **argv, const TestConfig &cfg, const bool new // utility lambdas to improve readability auto command = [&](const std::string &line) { - lmp->input->one(line.c_str()); + lmp->input->one(line); }; auto parse_input_script = [&](const std::string &filename) { lmp->input->file(filename.c_str()); @@ -142,7 +142,7 @@ void run_lammps(LAMMPS *lmp) { // utility lambda to improve readability auto command = [&](const std::string &line) { - lmp->input->one(line.c_str()); + lmp->input->one(line); }; command("fix 1 all nve"); @@ -157,7 +157,7 @@ void restart_lammps(LAMMPS *lmp, const TestConfig &cfg, bool nofdotr = false, bo { // utility lambda to improve readability auto command = [&](const std::string &line) { - lmp->input->one(line.c_str()); + lmp->input->one(line); }; command("clear"); @@ -188,7 +188,7 @@ void data_lammps(LAMMPS *lmp, const TestConfig &cfg) { // utility lambdas to improve readability auto command = [&](const std::string &line) { - lmp->input->one(line.c_str()); + lmp->input->one(line); }; auto parse_input_script = [&](const std::string &filename) { lmp->input->file(filename.c_str()); @@ -239,7 +239,7 @@ void generate_yaml_file(const char *outfile, const TestConfig &config) } const int natoms = lmp->atom->natoms; - std::string block(""); + std::string block; YamlWriter writer(outfile); @@ -316,7 +316,6 @@ void generate_yaml_file(const char *outfile, const TestConfig &config) writer.emit_block("run_forces", block); cleanup_lammps(lmp, config); - return; } TEST(PairStyle, plain) @@ -1085,7 +1084,7 @@ TEST(PairStyle, single) // utility lambda to improve readability auto command = [&](const std::string &line) { - lmp->input->one(line.c_str()); + lmp->input->one(line); }; command("clear"); @@ -1317,7 +1316,7 @@ TEST(PairStyle, extract) // utility lambda to improve readability auto command = [&](const std::string &line) { - lmp->input->one(line.c_str()); + lmp->input->one(line); }; if (!verbose) ::testing::internal::CaptureStdout(); diff --git a/unittest/formats/test_dump_atom.cpp b/unittest/formats/test_dump_atom.cpp index d1b22d7827..702325f2fb 100644 --- a/unittest/formats/test_dump_atom.cpp +++ b/unittest/formats/test_dump_atom.cpp @@ -39,22 +39,23 @@ public: END_HIDE_OUTPUT(); } - std::string dump_filename(std::string ident) + std::string dump_filename(const std::string &ident) { return fmt::format("dump_{}_{}.melt", dump_style, ident); } - std::string text_dump_filename(std::string ident) + std::string text_dump_filename(const std::string &ident) { return fmt::format("dump_{}_text_{}.melt", dump_style, ident); } - std::string binary_dump_filename(std::string ident) + std::string binary_dump_filename(const std::string &ident) { return fmt::format("dump_{}_binary_{}.melt.bin", dump_style, ident); } - void generate_dump(std::string dump_file, std::string dump_modify_options, int ntimesteps) + void generate_dump(const std::string &dump_file, const std::string &dump_modify_options, + int ntimesteps) { BEGIN_HIDE_OUTPUT(); command(fmt::format("dump id all {} 1 {}", dump_style, dump_file)); @@ -81,8 +82,8 @@ public: END_HIDE_OUTPUT(); } - void generate_text_and_binary_dump(std::string text_file, std::string binary_file, - std::string dump_modify_options, int ntimesteps) + void generate_text_and_binary_dump(const std::string &text_file, const std::string &binary_file, + const std::string &dump_modify_options, int ntimesteps) { BEGIN_HIDE_OUTPUT(); command(fmt::format("dump id0 all {} 1 {}", dump_style, text_file)); @@ -97,7 +98,7 @@ public: END_HIDE_OUTPUT(); } - std::string convert_binary_to_text(std::string binary_file) + std::string convert_binary_to_text(const std::string &binary_file) { BEGIN_HIDE_OUTPUT(); std::string cmdline = fmt::format("\"{}\" {}", BINARY2TXT_EXECUTABLE, binary_file); diff --git a/unittest/formats/test_dump_cfg.cpp b/unittest/formats/test_dump_cfg.cpp index c2ab96c5ed..e51da8331a 100644 --- a/unittest/formats/test_dump_cfg.cpp +++ b/unittest/formats/test_dump_cfg.cpp @@ -27,8 +27,8 @@ class DumpCfgTest : public MeltTest { std::string dump_style = "cfg"; public: - void generate_dump(std::string dump_file, std::string fields, std::string dump_modify_options, - int ntimesteps) + void generate_dump(const std::string &dump_file, const std::string &fields, + const std::string &dump_modify_options, int ntimesteps) { BEGIN_HIDE_OUTPUT(); command(fmt::format("dump id all {} 1 {} {}", dump_style, dump_file, fields)); diff --git a/unittest/formats/test_dump_custom.cpp b/unittest/formats/test_dump_custom.cpp index 39cb4ffd27..72b4adcc87 100644 --- a/unittest/formats/test_dump_custom.cpp +++ b/unittest/formats/test_dump_custom.cpp @@ -37,23 +37,23 @@ public: END_HIDE_OUTPUT(); } - std::string dump_filename(std::string ident) + std::string dump_filename(const std::string &ident) { return fmt::format("dump_{}_{}.melt", dump_style, ident); } - std::string text_dump_filename(std::string ident) + std::string text_dump_filename(const std::string &ident) { return fmt::format("dump_{}_text_{}.melt", dump_style, ident); } - std::string binary_dump_filename(std::string ident) + std::string binary_dump_filename(const std::string &ident) { return fmt::format("dump_{}_binary_{}.melt.bin", dump_style, ident); } - void generate_dump(std::string dump_file, std::string fields, std::string dump_modify_options, - int ntimesteps) + void generate_dump(const std::string &dump_file, const std::string &fields, + const std::string &dump_modify_options, int ntimesteps) { BEGIN_HIDE_OUTPUT(); command(fmt::format("dump id all {} 1 {} {}", dump_style, dump_file, fields)); @@ -80,9 +80,9 @@ public: END_HIDE_OUTPUT(); } - void generate_text_and_binary_dump(std::string text_file, std::string binary_file, - std::string fields, std::string dump_modify_options, - int ntimesteps) + void generate_text_and_binary_dump(const std::string &text_file, const std::string &binary_file, + const std::string &fields, + const std::string &dump_modify_options, int ntimesteps) { BEGIN_HIDE_OUTPUT(); command(fmt::format("dump id0 all {} 1 {} {}", dump_style, text_file, fields)); @@ -97,7 +97,7 @@ public: END_HIDE_OUTPUT(); } - std::string convert_binary_to_text(std::string binary_file) + std::string convert_binary_to_text(const std::string &binary_file) { BEGIN_HIDE_OUTPUT(); std::string cmdline = fmt::format("\"{}\" {}", BINARY2TXT_EXECUTABLE, binary_file); diff --git a/unittest/formats/test_dump_local.cpp b/unittest/formats/test_dump_local.cpp index 5471145309..c548427201 100644 --- a/unittest/formats/test_dump_local.cpp +++ b/unittest/formats/test_dump_local.cpp @@ -39,8 +39,8 @@ public: END_HIDE_OUTPUT(); } - void generate_dump(std::string dump_file, std::string dump_options, - std::string dump_modify_options, int ntimesteps) + void generate_dump(const std::string &dump_file, const std::string &dump_options, + const std::string &dump_modify_options, int ntimesteps) { BEGIN_HIDE_OUTPUT(); command(fmt::format("dump id all {} 1 {} {}", dump_style, dump_file, dump_options)); diff --git a/unittest/formats/test_file_operations.cpp b/unittest/formats/test_file_operations.cpp index fdb3e1a815..48d043b824 100644 --- a/unittest/formats/test_file_operations.cpp +++ b/unittest/formats/test_file_operations.cpp @@ -322,7 +322,7 @@ TEST_F(FileOperationsTest, write_restart) command("write_restart multi-%.restart"); command("write_restart multi2-%.restart fileper 2"); command("write_restart multi3-%.restart nfile 1"); - if (info->has_package("MPIIO")) command("write_restart test.restart.mpiio"); + if (Info::has_package("MPIIO")) command("write_restart test.restart.mpiio"); END_HIDE_OUTPUT(); ASSERT_FILE_EXISTS("noinit.restart"); @@ -334,11 +334,11 @@ TEST_F(FileOperationsTest, write_restart) ASSERT_FILE_EXISTS("multi2-0.restart"); ASSERT_FILE_EXISTS("multi3-base.restart"); ASSERT_FILE_EXISTS("multi3-0.restart"); - if (info->has_package("MPIIO")) { + if (Info::has_package("MPIIO")) { ASSERT_FILE_EXISTS("test.restart.mpiio"); } - if (!info->has_package("MPIIO")) { + if (!Info::has_package("MPIIO")) { TEST_FAILURE(".*ERROR: Writing to MPI-IO filename when MPIIO package is not inst.*", command("write_restart test.restart.mpiio");); } else { @@ -395,7 +395,7 @@ TEST_F(FileOperationsTest, write_restart) delete_file("multi3-base.restart"); delete_file("multi3-0.restart"); delete_file("triclinic.restart"); - if (info->has_package("MPIIO")) delete_file("test.restart.mpiio"); + if (Info::has_package("MPIIO")) delete_file("test.restart.mpiio"); } TEST_F(FileOperationsTest, write_data) @@ -492,7 +492,7 @@ int main(int argc, char **argv) MPI_Init(&argc, &argv); ::testing::InitGoogleMock(&argc, argv); - if (platform::mpi_vendor() == "Open MPI" && !LAMMPS_NS::Info::has_exceptions()) + if (platform::mpi_vendor() == "Open MPI" && !Info::has_exceptions()) std::cout << "Warning: using OpenMPI without exceptions. " "Death tests will be skipped\n"; diff --git a/unittest/python/test_python_package.cpp b/unittest/python/test_python_package.cpp index db7a7a41b6..377c3a7549 100644 --- a/unittest/python/test_python_package.cpp +++ b/unittest/python/test_python_package.cpp @@ -52,7 +52,7 @@ class PythonPackageTest : public LAMMPSTest { protected: void InitSystem() override { - if (!info->has_package("PYTHON")) GTEST_SKIP(); + if (!Info::has_package("PYTHON")) GTEST_SKIP(); HIDE_OUTPUT([&] { command("units real"); @@ -73,7 +73,7 @@ class FixPythonInvokeTest : public MeltTest { protected: void InitSystem() override { - if (!info->has_package("PYTHON")) GTEST_SKIP(); + if (!Info::has_package("PYTHON")) GTEST_SKIP(); MeltTest::InitSystem(); } @@ -309,7 +309,7 @@ TEST_F(FixPythonInvokeTest, end_of_step) auto output = CAPTURE_OUTPUT([&] { command("run 50"); }); - fprintf(stderr,"lines: %s\n",output.c_str()); + fprintf(stderr, "lines: %s\n", output.c_str()); auto lines = utils::split_lines(output); int count = 0; From b675372d992c6d606f5c2846008ba74f35a68ef2 Mon Sep 17 00:00:00 2001 From: Stan Gerald Moore Date: Tue, 31 May 2022 14:44:18 -0600 Subject: [PATCH 255/585] Use MIN_SINE and add comment --- src/KOKKOS/pair_reaxff_kokkos.cpp | 27 +++++++++++++++------------ 1 file changed, 15 insertions(+), 12 deletions(-) diff --git a/src/KOKKOS/pair_reaxff_kokkos.cpp b/src/KOKKOS/pair_reaxff_kokkos.cpp index c7924773a9..2764f665a6 100644 --- a/src/KOKKOS/pair_reaxff_kokkos.cpp +++ b/src/KOKKOS/pair_reaxff_kokkos.cpp @@ -3063,10 +3063,10 @@ void PairReaxFFKokkos::operator()(TagPairReaxComputeTorsionPreproces } sin_ijk = sin(theta_ijk); - if (sin_ijk >= 0 && sin_ijk <= 1e-10) - tan_ijk_i = cos_ijk / 1e-10; - else if (sin_ijk <= 0 && sin_ijk >= -1e-10) - tan_ijk_i = -cos_ijk / 1e-10; + if (sin_ijk >= 0 && sin_ijk <= MIN_SINE) + tan_ijk_i = cos_ijk / MIN_SINE; + else if (sin_ijk <= 0 && sin_ijk >= -MIN_SINE) + tan_ijk_i = -cos_ijk / MIN_SINE; else tan_ijk_i = cos_ijk / sin_ijk; exp_tor2_ik = exp(-p_tor2 * BOA_ik); @@ -3097,23 +3097,26 @@ void PairReaxFFKokkos::operator()(TagPairReaxComputeTorsionPreproces } sin_jil = sin(theta_jil); - if (sin_jil >= 0 && sin_jil <= 1e-10) - tan_jil_i = cos_jil / 1e-10; - else if (sin_jil <= 0 && sin_jil >= -1e-10) - tan_jil_i = -cos_jil / 1e-10; + if (sin_jil >= 0 && sin_jil <= MIN_SINE) + tan_jil_i = cos_jil / MIN_SINE; + else if (sin_jil <= 0 && sin_jil >= -MIN_SINE) + tan_jil_i = -cos_jil / MIN_SINE; else tan_jil_i = cos_jil / sin_jil; for (int d = 0; d < 3; d ++) dellk[d] = x(k,d) - x(l,d); const F_FLOAT rsqlk = dellk[0]*dellk[0] + dellk[1]*dellk[1] + dellk[2]*dellk[2]; const F_FLOAT rlk = sqrt(rsqlk); + // non-Kokkos ReaxFF has a separate function for computing omega, which + // limits the scope of the MIN_SINE statements below + F_FLOAT sin_ijk_rnd = sin_ijk; F_FLOAT sin_jil_rnd = sin_jil; - if (sin_ijk >= 0 && sin_ijk <= 1e-10) sin_ijk_rnd = 1e-10; - else if (sin_ijk <= 0 && sin_ijk >= -1e-10) sin_ijk_rnd = -1e-10; - if (sin_jil >= 0 && sin_jil <= 1e-10) sin_jil_rnd = 1e-10; - else if (sin_jil <= 0 && sin_jil >= -1e-10) sin_jil_rnd = -1e-10; + if (sin_ijk >= 0 && sin_ijk <= MIN_SINE) sin_ijk_rnd = MIN_SINE; + else if (sin_ijk <= 0 && sin_ijk >= -MIN_SINE) sin_ijk_rnd = -MIN_SINE; + if (sin_jil >= 0 && sin_jil <= MIN_SINE) sin_jil_rnd = MIN_SINE; + else if (sin_jil <= 0 && sin_jil >= -MIN_SINE) sin_jil_rnd = -MIN_SINE; F_FLOAT unnorm_cos_omega, unnorm_sin_omega, omega; F_FLOAT htra, htrb, htrc, hthd, hthe, hnra, hnrc, hnhd, hnhe; From ef6c48dad7f563c707cec52eec30029a236f1c24 Mon Sep 17 00:00:00 2001 From: Stan Gerald Moore Date: Tue, 31 May 2022 14:53:17 -0600 Subject: [PATCH 256/585] Whack tabs --- src/KOKKOS/pair_reaxff_kokkos.cpp | 20 ++++++++++---------- 1 file changed, 10 insertions(+), 10 deletions(-) diff --git a/src/KOKKOS/pair_reaxff_kokkos.cpp b/src/KOKKOS/pair_reaxff_kokkos.cpp index 2764f665a6..628241b8bd 100644 --- a/src/KOKKOS/pair_reaxff_kokkos.cpp +++ b/src/KOKKOS/pair_reaxff_kokkos.cpp @@ -2893,10 +2893,10 @@ void PairReaxFFKokkos::operator()(TagPairReaxComputeAngularPreproces p_coa1 = paramsthbp(jtype,itype,ktype).p_coa1; exp_coa2 = exp(p_coa2 * Delta_val); e_coa = p_coa1 / (1. + exp_coa2) * - exp(-p_coa3 * SQR(d_total_bo[j]-BOA_ij)) * - exp(-p_coa3 * SQR(d_total_bo[k]-BOA_ik)) * - exp(-p_coa4 * SQR(BOA_ij - 1.5)) * - exp(-p_coa4 * SQR(BOA_ik - 1.5)); + exp(-p_coa3 * SQR(d_total_bo[j]-BOA_ij)) * + exp(-p_coa3 * SQR(d_total_bo[k]-BOA_ik)) * + exp(-p_coa4 * SQR(BOA_ij - 1.5)) * + exp(-p_coa4 * SQR(BOA_ik - 1.5)); CEcoa1 = -2 * p_coa4 * (BOA_ij - 1.5) * e_coa; CEcoa2 = -2 * p_coa4 * (BOA_ik - 1.5) * e_coa; @@ -3148,7 +3148,7 @@ void PairReaxFFKokkos::operator()(TagPairReaxComputeTorsionPreproces hnhe = rik * rjl * sin_ijk_rnd * cos_jil; tel = SQR(rik) + SQR(rij) + SQR(rjl) - SQR(rlk) - - 2.0 * (rik * rij * cos_ijk - rik * rjl * cos_ijk * cos_jil + rij * rjl * cos_jil); + 2.0 * (rik * rij * cos_ijk - rik * rjl * cos_ijk * cos_jil + rij * rjl * cos_jil); poem = 2.0 * rik * rjl * sin_ijk_rnd * sin_jil_rnd; F_FLOAT inv_poem = 1.0 / poem; @@ -3180,12 +3180,12 @@ void PairReaxFFKokkos::operator()(TagPairReaxComputeTorsionPreproces if (eflag) ev.ereax[6] += e_tor; dfn11 = (-p_tor3 * exp_tor3_DiDj + (p_tor3 * exp_tor3_DiDj - p_tor4 * exp_tor4_DiDj) * - (2.0 + exp_tor3_DiDj) * exp_tor34_inv) * exp_tor34_inv; + (2.0 + exp_tor3_DiDj) * exp_tor34_inv) * exp_tor34_inv; CEtors1 = sin_ijk * sin_jil * CV; CEtors2 = -fn10 * 2.0 * p_tor1 * V2 * exp_tor1 * (2.0 - d_BO_pi(i,j_index) - f11_DiDj) * - (1.0 - SQR(cos_omega)) * sin_ijk * sin_jil; + (1.0 - SQR(cos_omega)) * sin_ijk * sin_jil; CEtors3 = CEtors2 * dfn11; CEtors4 = CEtors1 * p_tor2 * exp_tor2_ik * (1.0 - exp_tor2_ij) * (1.0 - exp_tor2_jl); @@ -3292,9 +3292,9 @@ void PairReaxFFKokkos::operator()(TagPairReaxComputeTorsionPreproces //if (eflag_atom) this->template ev_tally(ev,i,j,eng_tmp,0.0,0.0,0.0,0.0); if (eflag_atom) this->template e_tally(ev,i,j,eng_tmp); if (vflag_either) { - for (int d = 0; d < 3; d ++) delil[d] = x(l,d) - x(i,d); - for (int d = 0; d < 3; d ++) delkl[d] = x(l,d) - x(k,d); - this->template v_tally4(ev,k,i,j,l,fk_tmp,fi_tmp,fj_tmp,delkl,delil,deljl); + for (int d = 0; d < 3; d ++) delil[d] = x(l,d) - x(i,d); + for (int d = 0; d < 3; d ++) delkl[d] = x(l,d) - x(k,d); + this->template v_tally4(ev,k,i,j,l,fk_tmp,fi_tmp,fj_tmp,delkl,delil,deljl); } } } From 5abb6c76af34bf74d0267b67657e95cd665734ed Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 1 Jun 2022 02:13:02 -0400 Subject: [PATCH 257/585] small tweak --- unittest/force-styles/test_fix_timestep.cpp | 5 ++--- 1 file changed, 2 insertions(+), 3 deletions(-) diff --git a/unittest/force-styles/test_fix_timestep.cpp b/unittest/force-styles/test_fix_timestep.cpp index 64aa54e96b..981bc46eef 100644 --- a/unittest/force-styles/test_fix_timestep.cpp +++ b/unittest/force-styles/test_fix_timestep.cpp @@ -203,9 +203,8 @@ void generate_yaml_file(const char *outfile, const TestConfig &config) // run_stress, if enabled if (fix->thermo_virial) { auto stress = fix->virial; - block = fmt::format("{:23.16e} {:23.16e} {:23.16e} " - "{:23.16e} {:23.16e} {:23.16e}", - stress[0], stress[1], stress[2], stress[3], stress[4], stress[5]); + block = fmt::format("{:23.16e} {:23.16e} {:23.16e} {:23.16e} {:23.16e} {:23.16e}", + stress[0], stress[1], stress[2], stress[3], stress[4], stress[5]); writer.emit_block("run_stress", block); } From 9da3dd796ab4aeb9f3e391d980a2229f00ed1552 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 1 Jun 2022 02:30:25 -0400 Subject: [PATCH 258/585] delete undesired default members instead of making them inaccessible --- unittest/force-styles/test_config.h | 26 ++++++++++------------ unittest/force-styles/test_config_reader.h | 2 ++ unittest/force-styles/yaml_writer.h | 7 +++--- 3 files changed, 17 insertions(+), 18 deletions(-) diff --git a/unittest/force-styles/test_config.h b/unittest/force-styles/test_config.h index ef4d911b60..18b4b4f0b2 100644 --- a/unittest/force-styles/test_config.h +++ b/unittest/force-styles/test_config.h @@ -15,8 +15,8 @@ #define TEST_CONFIG_H #include -#include #include +#include #include #include @@ -96,23 +96,21 @@ public: restart_vel.clear(); global_vector.clear(); } - virtual ~TestConfig(){}; + TestConfig(const TestConfig &) = delete; + TestConfig &operator=(const TestConfig &) = delete; std::string tags_line() const { - if(tags.size() > 0) { - std::stringstream line; - line << tags[0]; - for(size_t i = 1; i < tags.size(); i++) { - line << ", " << tags[i]; - } - return line.str(); - } - return "generated"; + if (tags.size() > 0) { + std::stringstream line; + line << tags[0]; + for (size_t i = 1; i < tags.size(); i++) { + line << ", " << tags[i]; + } + return line.str(); + } + return "generated"; } - -private: - TestConfig(const TestConfig &){}; }; #endif diff --git a/unittest/force-styles/test_config_reader.h b/unittest/force-styles/test_config_reader.h index 1f0de8df0a..23da817622 100644 --- a/unittest/force-styles/test_config_reader.h +++ b/unittest/force-styles/test_config_reader.h @@ -22,6 +22,8 @@ class TestConfigReader : public YamlReader { public: TestConfigReader(TestConfig &config); + TestConfigReader() = delete; + const TestConfigReader & operator=(TestConfig &) = delete; void skip_tests(const yaml_event_t &event); void prerequisites(const yaml_event_t &event); diff --git a/unittest/force-styles/yaml_writer.h b/unittest/force-styles/yaml_writer.h index 31df8eb60d..ca95a578c1 100644 --- a/unittest/force-styles/yaml_writer.h +++ b/unittest/force-styles/yaml_writer.h @@ -22,6 +22,9 @@ class YamlWriter { public: YamlWriter(const char *outfile); virtual ~YamlWriter(); + YamlWriter() = delete; + YamlWriter(const YamlWriter &) = delete; + const YamlWriter & operator=(const YamlWriter &) = delete; // emitters void emit(const std::string &key, const double value); @@ -34,10 +37,6 @@ private: FILE *fp; yaml_emitter_t emitter; yaml_event_t event; - -private: - YamlWriter(){}; - YamlWriter(const YamlWriter &){}; }; #endif From 25f24fbab120740ed572fee9ffaf18e185b738ed Mon Sep 17 00:00:00 2001 From: Christoph Scherer Date: Wed, 1 Jun 2022 14:11:32 +0200 Subject: [PATCH 259/585] Update and rename pair_sw_3b_table.h to pair_sw_angle_table.h Renamed header file from sw/3b/table to sw/angle/table --- .../{pair_sw_3b_table.h => pair_sw_angle_table.h} | 12 ++++++------ 1 file changed, 6 insertions(+), 6 deletions(-) rename src/MANYBODY/{pair_sw_3b_table.h => pair_sw_angle_table.h} (91%) diff --git a/src/MANYBODY/pair_sw_3b_table.h b/src/MANYBODY/pair_sw_angle_table.h similarity index 91% rename from src/MANYBODY/pair_sw_3b_table.h rename to src/MANYBODY/pair_sw_angle_table.h index 187b815c1c..6257d18283 100644 --- a/src/MANYBODY/pair_sw_3b_table.h +++ b/src/MANYBODY/pair_sw_angle_table.h @@ -13,21 +13,21 @@ #ifdef PAIR_CLASS // clang-format off -PairStyle(sw/3b/table,PairSW3BTable); +PairStyle(sw/angle/table,PairSWAngleTable); // clang-format on #else -#ifndef LMP_PAIR_SW_3B_TABLE_H -#define LMP_PAIR_SW_3B_TABLE_H +#ifndef LMP_PAIR_SW_ANGLE_TABLE_H +#define LMP_PAIR_SW_ANGLE_TABLE_H #include "pair_sw.h" namespace LAMMPS_NS { -class PairSW3BTable : public PairSW { +class PairSWAngleTable : public PairSW { public: - PairSW3BTable(class LAMMPS *); - ~PairSW3BTable() override; + PairSWAngleTable(class LAMMPS *); + ~PairSWAngleTable() override; void compute(int, int) override; static constexpr int NPARAMS_PER_LINE = 18; From 8dfa4a8682644bbd52620953a62c94238c81d649 Mon Sep 17 00:00:00 2001 From: Christoph Scherer Date: Wed, 1 Jun 2022 14:20:30 +0200 Subject: [PATCH 260/585] Update and rename pair_sw_3b_table.cpp to pair_sw_angle_table.cpp Changed .cpp file for pair style sw/3b/table to sw/angle/table --- ...w_3b_table.cpp => pair_sw_angle_table.cpp} | 40 +++++++++---------- 1 file changed, 20 insertions(+), 20 deletions(-) rename src/MANYBODY/{pair_sw_3b_table.cpp => pair_sw_angle_table.cpp} (95%) diff --git a/src/MANYBODY/pair_sw_3b_table.cpp b/src/MANYBODY/pair_sw_angle_table.cpp similarity index 95% rename from src/MANYBODY/pair_sw_3b_table.cpp rename to src/MANYBODY/pair_sw_angle_table.cpp index a614e428e0..fbef0a6dd9 100644 --- a/src/MANYBODY/pair_sw_3b_table.cpp +++ b/src/MANYBODY/pair_sw_angle_table.cpp @@ -17,7 +17,7 @@ scherer@mpip-mainz.mpg.de ------------------------------------------------------------------------- */ -#include "pair_sw_3b_table.h" +#include "pair_sw_angle_table.h" #include "atom.h" #include "comm.h" @@ -47,7 +47,7 @@ static constexpr double TINY = 1.0e-10; /* ---------------------------------------------------------------------- */ -PairSW3BTable::PairSW3BTable(LAMMPS *lmp) : PairSW(lmp), table_params(nullptr) +PairSWAngleTable::PairSWAngleTable(LAMMPS *lmp) : PairSW(lmp), table_params(nullptr) { unit_convert_flag = utils::NOCONVERT; } @@ -56,7 +56,7 @@ PairSW3BTable::PairSW3BTable(LAMMPS *lmp) : PairSW(lmp), table_params(nullptr) check if allocated, since class can be destructed when incomplete ------------------------------------------------------------------------- */ -PairSW3BTable::~PairSW3BTable() +PairSWAngleTable::~PairSWAngleTable() { if (copymode) return; @@ -74,7 +74,7 @@ PairSW3BTable::~PairSW3BTable() /* ---------------------------------------------------------------------- */ -void PairSW3BTable::compute(int eflag, int vflag) +void PairSWAngleTable::compute(int eflag, int vflag) { int i,j,k,ii,jj,kk,inum,jnum,jnumm1; int itype,jtype,ktype,ijparam,ikparam,ijkparam; @@ -217,7 +217,7 @@ void PairSW3BTable::compute(int eflag, int vflag) /* ---------------------------------------------------------------------- */ -void PairSW3BTable::read_file(char *file) +void PairSWAngleTable::read_file(char *file) { memory->sfree(params); params = nullptr; @@ -228,7 +228,7 @@ void PairSW3BTable::read_file(char *file) // open file on proc 0 if (comm->me == 0) { - PotentialFileReader reader(lmp, file, "sw/3b", unit_convert_flag); + PotentialFileReader reader(lmp, file, "sw/angle/table", unit_convert_flag); char *line; while ((line = reader.next_line(NPARAMS_PER_LINE))) { @@ -300,7 +300,7 @@ void PairSW3BTable::read_file(char *file) auto tablestyle = values.next_string(); if (tablestyle == "linear") table_params[nparams].tabstyle = LINEAR; else if (tablestyle == "spline") table_params[nparams].tabstyle = SPLINE; - else error->all(FLERR,"Unknown table style {} of 3b/table file", tablestyle); + else error->all(FLERR,"Unknown table style {} of angle table file", tablestyle); table_params[nparams].tablength = values.next_int(); } catch (TokenizerException &e) { @@ -378,7 +378,7 @@ void PairSW3BTable::read_file(char *file) /* ---------------------------------------------------------------------- */ -void PairSW3BTable::threebody_table(Param *paramij, Param *paramik, ParamTable *table_paramijk, +void PairSWAngleTable::threebody_table(Param *paramij, Param *paramik, ParamTable *table_paramijk, double rsq1, double rsq2, double *delr1, double *delr2, double *fj, double *fk, int eflag, double &eng) { @@ -438,9 +438,9 @@ void PairSW3BTable::threebody_table(Param *paramij, Param *paramik, ParamTable * read table file, only called by proc 0 ------------------------------------------------------------------------- */ -void PairSW3BTable::read_table(Table *tb, char *file, char *keyword) +void PairSWAngleTable::read_table(Table *tb, char *file, char *keyword) { - TableFileReader reader(lmp, file, "3b/table"); + TableFileReader reader(lmp, file, "angle table"); char *line = reader.find_section_start(keyword); @@ -484,7 +484,7 @@ void PairSW3BTable::read_table(Table *tb, char *file, char *keyword) this function sets these values in e2file,f2file ------------------------------------------------------------------------- */ -void PairSW3BTable::spline_table(Table *tb) +void PairSWAngleTable::spline_table(Table *tb) { memory->create(tb->e2file, tb->ninput, "angle:e2file"); memory->create(tb->f2file, tb->ninput, "angle:f2file"); @@ -508,7 +508,7 @@ void PairSW3BTable::spline_table(Table *tb) compute a,e,f vectors from splined values ------------------------------------------------------------------------- */ -void PairSW3BTable::compute_table(Table *tb,int length) +void PairSWAngleTable::compute_table(Table *tb,int length) { // delta = table spacing in angle for N-1 bins @@ -558,7 +558,7 @@ void PairSW3BTable::compute_table(Table *tb,int length) ninput,afile,efile,ffile,fpflag,fplo,fphi,theta0 ------------------------------------------------------------------------- */ -void PairSW3BTable::bcast_table(Table *tb) +void PairSWAngleTable::bcast_table(Table *tb) { MPI_Bcast(&tb->ninput, 1, MPI_INT, 0, world); @@ -584,7 +584,7 @@ void PairSW3BTable::bcast_table(Table *tb) /* ---------------------------------------------------------------------- */ -void PairSW3BTable::null_table(Table *tb) +void PairSWAngleTable::null_table(Table *tb) { tb->afile = tb->efile = tb->ffile = nullptr; tb->e2file = tb->f2file = nullptr; @@ -594,7 +594,7 @@ void PairSW3BTable::null_table(Table *tb) /* ---------------------------------------------------------------------- */ -void PairSW3BTable::free_table(Table *tb) +void PairSWAngleTable::free_table(Table *tb) { memory->destroy(tb->afile); memory->destroy(tb->efile); @@ -613,7 +613,7 @@ void PairSW3BTable::free_table(Table *tb) /* ---------------------------------------------------------------------- */ -void PairSW3BTable::free_param(ParamTable *pm) +void PairSWAngleTable::free_param(ParamTable *pm) { // call free_table to destroy associated angle table free_table(pm->angtable); @@ -631,7 +631,7 @@ void PairSW3BTable::free_param(ParamTable *pm) only called by read_table, only called by proc 0 ------------------------------------------------------------------------- */ -void PairSW3BTable::param_extract(Table *tb, char *line) +void PairSWAngleTable::param_extract(Table *tb, char *line) { tb->ninput = 0; tb->fpflag = 0; @@ -668,7 +668,7 @@ void PairSW3BTable::param_extract(Table *tb, char *line) spline and splint routines modified from Numerical Recipes ------------------------------------------------------------------------- */ -void PairSW3BTable::spline(double *x, double *y, int n, double yp1, double ypn, double *y2) +void PairSWAngleTable::spline(double *x, double *y, int n, double yp1, double ypn, double *y2) { int i, k; double p, qn, sig, un; @@ -700,7 +700,7 @@ void PairSW3BTable::spline(double *x, double *y, int n, double yp1, double ypn, } /* ---------------------------------------------------------------------- */ -double PairSW3BTable::splint(double *xa, double *ya, double *y2a, int n, double x) +double PairSWAngleTable::splint(double *xa, double *ya, double *y2a, int n, double x) { int klo, khi, k; double h, b, a, y; @@ -726,7 +726,7 @@ double PairSW3BTable::splint(double *xa, double *ya, double *y2a, int n, double calculate potential u and force f at angle x ------------------------------------------------------------------------- */ -void PairSW3BTable::uf_lookup(ParamTable *pm, double x, double &u, double &f) +void PairSWAngleTable::uf_lookup(ParamTable *pm, double x, double &u, double &f) { if (!std::isfinite(x)) { error->one(FLERR, "Illegal angle in angle style table"); } From ebce66389e1d37b05689fd279625b1cfebb193b7 Mon Sep 17 00:00:00 2001 From: Christoph Scherer Date: Wed, 1 Jun 2022 14:24:40 +0200 Subject: [PATCH 261/585] Update and rename pair_sw_3b_table.rst to pair_sw_angle_table.rst changed documentation and file name from sw/3b/table to sw/angle/table --- ...sw_3b_table.rst => pair_sw_angle_table.rst} | 18 +++++++++--------- 1 file changed, 9 insertions(+), 9 deletions(-) rename doc/src/{pair_sw_3b_table.rst => pair_sw_angle_table.rst} (96%) diff --git a/doc/src/pair_sw_3b_table.rst b/doc/src/pair_sw_angle_table.rst similarity index 96% rename from doc/src/pair_sw_3b_table.rst rename to doc/src/pair_sw_angle_table.rst index 2d57803a61..a50b7eaaf5 100644 --- a/doc/src/pair_sw_3b_table.rst +++ b/doc/src/pair_sw_angle_table.rst @@ -1,6 +1,6 @@ -.. index:: pair_style sw/3b/table +.. index:: pair_style sw/angle/table -pair_style sw/3b/table command +pair_style sw/angle/table command ============================== Syntax @@ -10,7 +10,7 @@ Syntax pair_style style -* style = *sw/3b/table* +* style = *sw/angle/table* Examples @@ -18,7 +18,7 @@ Examples .. code-block:: LAMMPS - pair_style sw/3b/table + pair_style sw/angle/table pair_coeff * * spce.sw type pair_coeff * * GaN.sw Ga N Ga @@ -26,7 +26,7 @@ Examples Description """"""""""" -The *sw/3b/table* style is a modification of the original +The *sw/angle/table* style is a modification of the original :doc:`pair_style sw `. It has been developed for coarse-grained simulations (of water) (:ref:`Scherer1 `), but can be employed for all kinds of systems. It computes a modified 3-body @@ -48,12 +48,12 @@ system of atoms as where :math:`\phi_2` is a two-body term and :math:`\phi_3` is a three-body term. The summations in the formula are over all neighbors J and K of atom I within a cutoff distance :math:`a \sigma`. -In contrast to the original *sw* style, *sw/3b/table* allows for a flexible +In contrast to the original *sw* style, *sw/angle/table* allows for a flexible three-body term :math:`f^{\textrm{3b}}\left(\theta_{ijk}\right)` which is read in as a tabulated interaction. It can be parameterized with the csg_fmatch app of VOTCA as available at: https://gitlab.mpcdf.mpg.de/votca/votca. -Only a single pair_coeff command is used with the *sw/3b/table* style +Only a single pair_coeff command is used with the *sw/angle/table* style which specifies a modified Stillinger-Weber potential file with parameters for all needed elements. These are mapped to LAMMPS atom types by specifying N_el additional arguments after the ".sw" filename in the pair_coeff command, @@ -78,7 +78,7 @@ The first 2 arguments must be \* \* so as to span all LAMMPS atom types. The first three Si arguments map LAMMPS atom types 1,2,3 to the Si element in the SW file. The final C argument maps LAMMPS atom type 4 to the C element in the SW file. If a mapping value is specified as -NULL, the mapping is not performed. This can be used when a *sw/3b/table* +NULL, the mapping is not performed. This can be used when a *sw/angle/table* potential is used as part of the *hybrid* pair style. The NULL values are placeholders for atom types that will be used with other potentials. @@ -298,7 +298,7 @@ in the tutorial folder. Related commands """""""""""""""" -:doc:`pair_coeff `, :doc:`pair_style sw `, :doc:`pair_style 3b/table ` +:doc:`pair_coeff `, :doc:`pair_style sw `, :doc:`pair_style threebody/table ` ---------- From 5756dedfed15bdabdfa8dde85b34edf33f45b7ad Mon Sep 17 00:00:00 2001 From: Christoph Scherer Date: Wed, 1 Jun 2022 15:52:46 +0200 Subject: [PATCH 262/585] Update and rename pair_3b_table.h to pair_threebody_table.h changed pair style and file name of header file from 3b/table to threebody/table --- .../{pair_3b_table.h => pair_threebody_table.h} | 16 ++++++++-------- 1 file changed, 8 insertions(+), 8 deletions(-) rename src/MANYBODY/{pair_3b_table.h => pair_threebody_table.h} (88%) diff --git a/src/MANYBODY/pair_3b_table.h b/src/MANYBODY/pair_threebody_table.h similarity index 88% rename from src/MANYBODY/pair_3b_table.h rename to src/MANYBODY/pair_threebody_table.h index a250fe1b2a..218bfeebd8 100644 --- a/src/MANYBODY/pair_3b_table.h +++ b/src/MANYBODY/pair_threebody_table.h @@ -13,21 +13,21 @@ #ifdef PAIR_CLASS // clang-format off -PairStyle(3b/table,Pair3BTable); +PairStyle(threebody/table,PairThreebodyTable); // clang-format on #else -#ifndef LMP_PAIR_3B_TABLE_H -#define LMP_PAIR_3B_TABLE_H +#ifndef LMP_PAIR_THREEBODY_TABLE_H +#define LMP_PAIR_THREEBODY_TABLE_H #include "pair.h" namespace LAMMPS_NS { -class Pair3BTable : public Pair { +class PairThreebodyTable : public Pair { public: - Pair3BTable(class LAMMPS *); - ~Pair3BTable() override; + PairThreebodyTable(class LAMMPS *); + ~PairThreebodyTable() override; void compute(int, int) override; void coeff(int, char **) override; double init_one(int, int) override; @@ -37,7 +37,7 @@ class Pair3BTable : public Pair { // no write or read from binary restart file - // struct for 3b/table + // struct for threebody/table struct Table { int ninput; double rmin, rmax; @@ -54,7 +54,7 @@ class Pair3BTable : public Pair { int keywordlength; // length of key in table char *keyword; // key in table int tabstyle, tablength; // length of interpolation table (not ninput) and style - Table *mltable; // 3b Table + Table *mltable; // threebody table }; protected: From 187ccdd2223bb5cd2101e57789d45c5a8276f0fb Mon Sep 17 00:00:00 2001 From: Christoph Scherer Date: Wed, 1 Jun 2022 16:03:06 +0200 Subject: [PATCH 263/585] Update and rename pair_3b_table.cpp to pair_threebody_table.cpp changed pair 3b/table to pair threebody/table including name of .cpp file --- ..._3b_table.cpp => pair_threebody_table.cpp} | 84 +++++++++---------- 1 file changed, 42 insertions(+), 42 deletions(-) rename src/MANYBODY/{pair_3b_table.cpp => pair_threebody_table.cpp} (90%) diff --git a/src/MANYBODY/pair_3b_table.cpp b/src/MANYBODY/pair_threebody_table.cpp similarity index 90% rename from src/MANYBODY/pair_3b_table.cpp rename to src/MANYBODY/pair_threebody_table.cpp index 00af61ee82..201e2a77a2 100644 --- a/src/MANYBODY/pair_3b_table.cpp +++ b/src/MANYBODY/pair_threebody_table.cpp @@ -16,7 +16,7 @@ scherer@mpip-mainz.mpg.de ------------------------------------------------------------------------- */ -#include "pair_3b_table.h" +#include "pair_threebody_table.h" #include "atom.h" #include "comm.h" @@ -41,7 +41,7 @@ using MathConst::MY_PI; /* ---------------------------------------------------------------------- */ -Pair3BTable::Pair3BTable(LAMMPS *lmp) : Pair(lmp), params(nullptr), neighshort(nullptr) +PairThreebodyTable::PairThreebodyTable(LAMMPS *lmp) : Pair(lmp), params(nullptr), neighshort(nullptr) { single_enable = 0; restartinfo = 0; @@ -56,7 +56,7 @@ Pair3BTable::Pair3BTable(LAMMPS *lmp) : Pair(lmp), params(nullptr), neighshort(n check if allocated, since class can be destructed when incomplete ------------------------------------------------------------------------- */ -Pair3BTable::~Pair3BTable() +PairThreebodyTable::~PairThreebodyTable() { if (copymode) return; @@ -73,7 +73,7 @@ Pair3BTable::~Pair3BTable() /* ---------------------------------------------------------------------- */ -void Pair3BTable::compute(int eflag, int vflag) +void PairThreebodyTable::compute(int eflag, int vflag) { int i,j,k,ii,jj,kk,inum,jnum,jnumm1; int itype,jtype,ktype,ijparam,ijkparam; @@ -202,7 +202,7 @@ void Pair3BTable::compute(int eflag, int vflag) /* ---------------------------------------------------------------------- */ -void Pair3BTable::allocate() +void PairThreebodyTable::allocate() { allocated = 1; int n = atom->ntypes; @@ -217,7 +217,7 @@ void Pair3BTable::allocate() global settings ------------------------------------------------------------------------- */ -void Pair3BTable::settings(int narg, char ** /*arg*/) +void PairThreebodyTable::settings(int narg, char ** /*arg*/) { if (narg != 0) error->all(FLERR,"Illegal pair_style command"); } @@ -226,7 +226,7 @@ void Pair3BTable::settings(int narg, char ** /*arg*/) set coeffs for one or more type pairs ------------------------------------------------------------------------- */ -void Pair3BTable::coeff(int narg, char **arg) +void PairThreebodyTable::coeff(int narg, char **arg) { if (!allocated) allocate(); @@ -242,12 +242,12 @@ void Pair3BTable::coeff(int narg, char **arg) init specific to this pair style ------------------------------------------------------------------------- */ -void Pair3BTable::init_style() +void PairThreebodyTable::init_style() { if (atom->tag_enable == 0) - error->all(FLERR,"Pair style 3b/table requires atom IDs"); + error->all(FLERR,"Pair style threebody/table requires atom IDs"); if (force->newton_pair == 0) - error->all(FLERR,"Pair style 3b/table requires newton pair on"); + error->all(FLERR,"Pair style threebody/table requires newton pair on"); // need a full neighbor list @@ -258,7 +258,7 @@ void Pair3BTable::init_style() init for one type pair i,j and corresponding j,i ------------------------------------------------------------------------- */ -double Pair3BTable::init_one(int i, int j) +double PairThreebodyTable::init_one(int i, int j) { if (setflag[i][j] == 0) error->all(FLERR,"All pair coeffs are not set"); @@ -267,7 +267,7 @@ double Pair3BTable::init_one(int i, int j) /* ---------------------------------------------------------------------- */ -void Pair3BTable::read_file(char *file) +void PairThreebodyTable::read_file(char *file) { memory->sfree(params); params = nullptr; @@ -276,7 +276,7 @@ void Pair3BTable::read_file(char *file) // open file on proc 0 if (comm->me == 0) { - PotentialFileReader reader(lmp, file, "3b/table", unit_convert_flag); + PotentialFileReader reader(lmp, file, "threebody", unit_convert_flag); char *line; while ((line = reader.next_line(NPARAMS_PER_LINE))) { @@ -339,7 +339,7 @@ void Pair3BTable::read_file(char *file) } auto tablestyle = values.next_string(); if (tablestyle != "linear") - error->all(FLERR,"Unknown table style {} in 3b table", tablestyle); + error->all(FLERR,"Unknown table style {} in threebody table", tablestyle); params[nparams].tablength = values.next_int(); } catch (TokenizerException &e) { @@ -347,7 +347,7 @@ void Pair3BTable::read_file(char *file) } if (params[nparams].cut < 0.0 || params[nparams].tablength < 0.0) - error->one(FLERR,"Illegal 3b/table parameters"); + error->one(FLERR,"Illegal threebody/table parameters"); nparams++; } @@ -362,7 +362,7 @@ void Pair3BTable::read_file(char *file) MPI_Bcast(params, maxparam*sizeof(Param), MPI_BYTE, 0, world); - // for each set of parameters, broadcast table name and keyword and read 3b table + // for each set of parameters, broadcast table name and keyword and read threebody table for (int m = 0; m < nparams; ++m){ if (comm->me != 0) { memory->create(params[m].tablename, params[m].tablenamelength, "params.tablename"); @@ -373,27 +373,27 @@ void Pair3BTable::read_file(char *file) } MPI_Bcast(¶ms[m].keyword, params[m].keywordlength, MPI_CHAR, 0, world); - // initialize 3btable - memory->create(params[m].mltable,1,"param:3btable"); + // initialize threebodytable + memory->create(params[m].mltable,1,"param:threebodytable"); null_table(params[m].mltable); - //call read_table to read corresponding tabulated 3b file (only called by process 0) + //call read_table to read corresponding tabulated threebody file (only called by process 0) if (comm->me == 0){ read_table(params[m].mltable,params[m].tablename,params[m].keyword,params[m].symmetric); } - // broadcast read in 3btable to all processes + // broadcast read in threebodytable to all processes bcast_table(params[m].mltable,params[m].symmetric); // error check on table parameters - if (params[m].mltable->ninput <= 1) error->one(FLERR,"Invalid 3b table length"); + if (params[m].mltable->ninput <= 1) error->one(FLERR,"Invalid threebody table length"); } } /* ---------------------------------------------------------------------- */ -void Pair3BTable::setup_params() +void PairThreebodyTable::setup_params() { int i,j,k,m,n; double rtmp; @@ -446,9 +446,9 @@ void Pair3BTable::setup_params() read table file, only called by proc 0 ------------------------------------------------------------------------- */ -void Pair3BTable::read_table(Table *tb, char *file, char *keyword, bool symmetric) +void PairThreebodyTable::read_table(Table *tb, char *file, char *keyword, bool symmetric) { - TableFileReader reader(lmp, file, "3body"); + TableFileReader reader(lmp, file, "threebodytable"); char *line = reader.find_section_start(keyword); @@ -460,7 +460,7 @@ void Pair3BTable::read_table(Table *tb, char *file, char *keyword, bool symmetri line = reader.next_line(); param_extract(tb, line); - // if it is a symmetric 3body interaction, less table entries are required + // if it is a symmetric threebody interaction, less table entries are required if (symmetric == true){ memory->create(tb->r12file,tb->ninput*tb->ninput*(tb->ninput+1),"mltable:r12file"); memory->create(tb->r13file,tb->ninput*tb->ninput*(tb->ninput+1),"mltable:r13file"); @@ -488,11 +488,11 @@ void Pair3BTable::read_table(Table *tb, char *file, char *keyword, bool symmetri } - // read 3b table values from file + // read threebody table values from file int cerror = 0; reader.skip_line(); - // if it is a symmetric 3body interaction, less table entries are required + // if it is a symmetric threebody interaction, less table entries are required if (symmetric == true){ for (int i = 0; i < tb->ninput*tb->ninput*(tb->ninput+1); i++) { line = reader.next_line(11); @@ -551,7 +551,7 @@ void Pair3BTable::read_table(Table *tb, char *file, char *keyword, bool symmetri only called by read_table, only called by proc 0 ------------------------------------------------------------------------- */ -void Pair3BTable::param_extract(Table *tb, char *line) +void PairThreebodyTable::param_extract(Table *tb, char *line) { tb->ninput = 0; tb->rmin = 0.0; @@ -577,9 +577,9 @@ void Pair3BTable::param_extract(Table *tb, char *line) error->one(FLERR, e.what()); } - if (tb->ninput == 0) error->one(FLERR, "3body table parameters did not set N"); - if (tb->rmin == 0.0) error->one(FLERR, "3body table parameters did not set rmin"); - if (tb->rmax == 0.0) error->one(FLERR, "3body table parameters did not set rmax"); + if (tb->ninput == 0) error->one(FLERR, "threebodytable parameters did not set N"); + if (tb->rmin == 0.0) error->one(FLERR, "threebodytable parameters did not set rmin"); + if (tb->rmax == 0.0) error->one(FLERR, "threebodytable parameters did not set rmax"); } @@ -589,14 +589,14 @@ void Pair3BTable::param_extract(Table *tb, char *line) ninput,afile,efile,ffile,fpflag,fplo,fphi,theta0 ------------------------------------------------------------------------- */ -void Pair3BTable::bcast_table(Table *tb, bool symmetric) +void PairThreebodyTable::bcast_table(Table *tb, bool symmetric) { MPI_Bcast(&tb->ninput,1,MPI_INT,0,world); int me; MPI_Comm_rank(world, &me); if (me > 0) { - // if it is a symmetric 3body interaction, less table entries are required + // if it is a symmetric threebody interaction, less table entries are required if (symmetric == true){ memory->create(tb->r12file,tb->ninput*tb->ninput*(tb->ninput+1),"mltable:r12file"); memory->create(tb->r13file,tb->ninput*tb->ninput*(tb->ninput+1),"mltable:r13file"); @@ -624,7 +624,7 @@ void Pair3BTable::bcast_table(Table *tb, bool symmetric) } } - // if it is a symmetric 3body interaction, less table entries are required + // if it is a symmetric threebody interaction, less table entries are required if (symmetric == true){ MPI_Bcast(tb->r12file,tb->ninput*tb->ninput*(tb->ninput+1),MPI_DOUBLE,0,world); MPI_Bcast(tb->r13file,tb->ninput*tb->ninput*(tb->ninput+1),MPI_DOUBLE,0,world); @@ -657,11 +657,11 @@ void Pair3BTable::bcast_table(Table *tb, bool symmetric) /* ---------------------------------------------------------------------- */ -void Pair3BTable::free_param(Param *pm) +void PairThreebodyTable::free_param(Param *pm) { - // call free_table to destroy associated 3btable + // call free_table to destroy associated threebodytable free_table(pm->mltable); - // then destroy associated 3btable + // then destroy associated threebodytable memory->sfree(pm->tablename); memory->sfree(pm->keyword); memory->sfree(pm->mltable); @@ -669,7 +669,7 @@ void Pair3BTable::free_param(Param *pm) /* ---------------------------------------------------------------------- */ -void Pair3BTable::free_table(Table *tb) +void PairThreebodyTable::free_table(Table *tb) { memory->destroy(tb->r12file); memory->destroy(tb->r13file); @@ -685,7 +685,7 @@ void Pair3BTable::free_table(Table *tb) /* ---------------------------------------------------------------------- */ -void Pair3BTable::null_table(Table *tb) +void PairThreebodyTable::null_table(Table *tb) { tb->r12file = tb->r13file = tb->thetafile = nullptr; tb->f11file = tb->f12file = nullptr; @@ -698,7 +698,7 @@ void Pair3BTable::null_table(Table *tb) calculate potential u and force f at angle x ------------------------------------------------------------------------- */ -void Pair3BTable::uf_lookup(Param *pm, double r12, double r13, double theta, double &f11, double &f12, +void PairThreebodyTable::uf_lookup(Param *pm, double r12, double r13, double theta, double &f11, double &f12, double &f21, double &f22, double &f31, double &f32, double &u) { int i,itable,nr12,nr13,ntheta; @@ -708,7 +708,7 @@ void Pair3BTable::uf_lookup(Param *pm, double r12, double r13, double theta, dou //lookup scheme - // if it is a symmetric 3body interaction, less table entries are required + // if it is a symmetric threebody interaction, less table entries are required if (pm->symmetric == true){ nr12 = (r12 - pm->mltable->rmin + 0.5*dr - 0.00000001)/dr; if (r12 == (pm->mltable->rmin - 0.5*dr)){ @@ -761,7 +761,7 @@ void Pair3BTable::uf_lookup(Param *pm, double r12, double r13, double theta, dou /* ---------------------------------------------------------------------- */ -void Pair3BTable::threebody(Param *paramijk, double rsq1, double rsq2, double *delr1, double *delr2, +void PairThreebodyTable::threebody(Param *paramijk, double rsq1, double rsq2, double *delr1, double *delr2, double *fi, double *fj, double *fk, int eflag, double &eng) { double r12,r13,theta,rinv,cs; From a833baac806b7b8a166209c007b8b0f31ba32a57 Mon Sep 17 00:00:00 2001 From: Christoph Scherer Date: Wed, 1 Jun 2022 16:04:09 +0200 Subject: [PATCH 264/585] Update pair_sw_angle_table.cpp Minor correction in pair_sw_angle_table.cpp --- src/MANYBODY/pair_sw_angle_table.cpp | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/src/MANYBODY/pair_sw_angle_table.cpp b/src/MANYBODY/pair_sw_angle_table.cpp index fbef0a6dd9..5da277bc05 100644 --- a/src/MANYBODY/pair_sw_angle_table.cpp +++ b/src/MANYBODY/pair_sw_angle_table.cpp @@ -228,7 +228,7 @@ void PairSWAngleTable::read_file(char *file) // open file on proc 0 if (comm->me == 0) { - PotentialFileReader reader(lmp, file, "sw/angle/table", unit_convert_flag); + PotentialFileReader reader(lmp, file, "sw", unit_convert_flag); char *line; while ((line = reader.next_line(NPARAMS_PER_LINE))) { @@ -440,7 +440,7 @@ void PairSWAngleTable::threebody_table(Param *paramij, Param *paramik, ParamTabl void PairSWAngleTable::read_table(Table *tb, char *file, char *keyword) { - TableFileReader reader(lmp, file, "angle table"); + TableFileReader reader(lmp, file, "angletable"); char *line = reader.find_section_start(keyword); From c1e301ac1af0a13726476b9e0a9233e42db8f65b Mon Sep 17 00:00:00 2001 From: Christoph Scherer Date: Wed, 1 Jun 2022 16:11:47 +0200 Subject: [PATCH 265/585] Update pair_3b_table.rst changed documentation and file name from pair style 3b/table to threebody/table --- doc/src/pair_3b_table.rst | 30 +++++++++++++++--------------- 1 file changed, 15 insertions(+), 15 deletions(-) diff --git a/doc/src/pair_3b_table.rst b/doc/src/pair_3b_table.rst index 0a239883e4..569979f78d 100644 --- a/doc/src/pair_3b_table.rst +++ b/doc/src/pair_3b_table.rst @@ -1,7 +1,7 @@ -.. index:: pair_style 3b/table +.. index:: pair_style threebody/table -pair_style 3b/table command -=========================== +pair_style threebody/table command +================================== Syntax """""" @@ -10,7 +10,7 @@ Syntax pair_style style -* style = *3b/table* +* style = *threebody/table* Examples @@ -18,7 +18,7 @@ Examples .. code-block:: LAMMPS - pair_style 3b/table + pair_style threebody/table pair_coeff * * spce.3b type pair_coeff * * GaN.3b Ga N Ga @@ -26,11 +26,11 @@ Examples Description """"""""""" -The *3b/table* style is a pair style for generic tabulated three-body +The *threebody/table* style is a pair style for generic tabulated three-body interactions. It has been developed for (coarse-grained) simulations (of water) with Kernel-based machine learning (ML) potentials (:ref:`Scherer2 `). As for the pair style :doc:`pair_style sw -` or :doc:`pair_style sw/3b/table `, the energy of +` or :doc:`pair_style sw/threebody/table `, the energy of a system is computed as a sum over three-body terms: .. math:: @@ -43,14 +43,14 @@ Stillinger-Weber potential, all forces are not calculated analytically, but read in from a three-body force/energy table which can be generated with the csg_ml app of VOTCA as available at: https://gitlab.mpcdf.mpg.de/votca/votca. -Only a single pair_coeff command is used with the *3b/table* style -which specifies a three-body potential (".3b") file with parameters for all +Only a single pair_coeff command is used with the *threebody/table* style +which specifies a threebody potential (".3b") file with parameters for all needed elements. These are then mapped to LAMMPS atom types by specifying N_el additional arguments after the ".3b" filename in the pair_coeff command, where N_el is the number of LAMMPS atom types: * ".3b" filename -* N_el element names = mapping of 3b elements to atom types +* N_el element names = mapping of threebody elements to atom types See the :doc:`pair_coeff ` page for alternate ways to specify the path for the potential file. @@ -67,8 +67,8 @@ pair_coeff command: The first 2 arguments must be \* \* so as to span all LAMMPS atom types. The first three Si arguments map LAMMPS atom types 1,2,3 to the Si element in the ".3b" file. The final C argument maps LAMMPS atom type 4 -to the C element in the 3b file. If a mapping value is specified as -NULL, the mapping is not performed. This can be used when a *3b/table* +to the C element in the threebody file. If a mapping value is specified as +NULL, the mapping is not performed. This can be used when a *threebody/table* potential is used as part of the *hybrid* pair style. The NULL values are placeholders for atom types that will be used with other potentials. @@ -193,7 +193,7 @@ This allows for a very efficient force calculation with the stored force constants and energies. Due to the know table structure, the lookup can be done efficiently. It has been tested (:ref:`Scherer2 `) that with a reasonably small bin size, the accuracy and speed is comparable to that of a Stillinger-Weber potential -with tabulated three-body interactions (:doc:`pair_style sw/table `) while +with tabulated three-body interactions (:doc:`pair_style sw/angle/table `) while the table format of this pair style allows for more flexible three-body interactions. As for the Stillinger-Weber potential, the three-body potential file must contain entries for all the @@ -204,7 +204,7 @@ simulation; LAMMPS ignores those entries. For a single-element simulation, only a single entry is required (e.g. SiSiSi). For a two-element simulation, the file must contain 8 entries (for SiSiSi, SiSiC, SiCSi, SiCC, CSiSi, CSiC, CCSi, CCC), that -specify 3b parameters for all permutations of the two elements +specify threebody parameters for all permutations of the two elements interacting in three-body configurations. Thus for 3 elements, 27 entries would be required, etc. @@ -254,7 +254,7 @@ in the tutorial folder. Related commands """""""""""""""" -:doc:`pair_coeff `, :doc:`pair sw/3b/table ` +:doc:`pair_coeff `, :doc:`pair sw/angle/table ` ---------- From 64d67f7604479649e7b0d2d05251c56fcaf283f8 Mon Sep 17 00:00:00 2001 From: Christoph Scherer Date: Wed, 1 Jun 2022 16:12:13 +0200 Subject: [PATCH 266/585] Update pair_sw_angle_table.rst pair_sw_angle_table.rst: minor correction --- doc/src/pair_sw_angle_table.rst | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/doc/src/pair_sw_angle_table.rst b/doc/src/pair_sw_angle_table.rst index a50b7eaaf5..cc2bbba08f 100644 --- a/doc/src/pair_sw_angle_table.rst +++ b/doc/src/pair_sw_angle_table.rst @@ -1,7 +1,7 @@ .. index:: pair_style sw/angle/table pair_style sw/angle/table command -============================== +================================= Syntax """""" From f6fab8365a65655c2a2a746aaadac88d93254b5c Mon Sep 17 00:00:00 2001 From: Christoph Scherer Date: Wed, 1 Jun 2022 16:14:37 +0200 Subject: [PATCH 267/585] Update Commands_pair.rst Commands_pair.rst: update due to name change from 3b/table to threebody/table and sw/3b/table to sw/angle/table --- doc/src/Commands_pair.rst | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/doc/src/Commands_pair.rst b/doc/src/Commands_pair.rst index 21a84a2518..f902b40b29 100644 --- a/doc/src/Commands_pair.rst +++ b/doc/src/Commands_pair.rst @@ -34,7 +34,6 @@ OPT. * * * - * :doc:`3b/table ` * :doc:`adp (ko) ` * :doc:`agni (o) ` * :doc:`airebo (io) ` @@ -270,7 +269,7 @@ OPT. * :doc:`spin/neel ` * :doc:`srp ` * :doc:`sw (giko) ` - * :doc:`sw/3b/table ` + * :doc:`sw/angle/table ` * :doc:`sw/mod (o) ` * :doc:`table (gko) ` * :doc:`table/rx (k) ` @@ -281,6 +280,7 @@ OPT. * :doc:`tersoff/table (o) ` * :doc:`tersoff/zbl (gko) ` * :doc:`thole ` + * :doc:`threebody/table ` * :doc:`tip4p/cut (o) ` * :doc:`tip4p/long (o) ` * :doc:`tip4p/long/soft (o) ` From 3a19b1eb4b9728c973f9eb78269e75387211cf08 Mon Sep 17 00:00:00 2001 From: Christoph Scherer Date: Wed, 1 Jun 2022 16:16:13 +0200 Subject: [PATCH 268/585] Update pair_style.rst pair_style.rst: update due to name changes from 3b/table to threebody/table and sw/3b/table to sw/angle/table --- doc/src/pair_style.rst | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/doc/src/pair_style.rst b/doc/src/pair_style.rst index d24596e2fa..7e9414cee9 100644 --- a/doc/src/pair_style.rst +++ b/doc/src/pair_style.rst @@ -112,7 +112,6 @@ accelerated styles exist. * :doc:`hybrid/scaled ` - multiple styles of scaled superposed pairwise interactions * :doc:`zero ` - neighbor list but no interactions -* :doc:`3b/table ` - generic tabulated three-body potential * :doc:`adp ` - angular dependent potential (ADP) of Mishin * :doc:`agni ` - AGNI machine-learning potential * :doc:`airebo ` - AIREBO potential of Stuart @@ -349,7 +348,7 @@ accelerated styles exist. * :doc:`spin/neel ` - * :doc:`srp ` - * :doc:`sw ` - Stillinger-Weber 3-body potential -* :doc:`sw/3b/table ` - Stillinger-Weber potential with tabulated 3-body term +* :doc:`sw/angle/table ` - Stillinger-Weber potential with tabulated angular term * :doc:`sw/mod ` - modified Stillinger-Weber 3-body potential * :doc:`table ` - tabulated pair potential * :doc:`table/rx ` - @@ -360,6 +359,7 @@ accelerated styles exist. * :doc:`tersoff/table ` - * :doc:`tersoff/zbl ` - Tersoff/ZBL 3-body potential * :doc:`thole ` - Coulomb interactions with thole damping +* :doc:`threebody/table ` - generic tabulated three-body potential * :doc:`tip4p/cut ` - Coulomb for TIP4P water w/out LJ * :doc:`tip4p/long ` - long-range Coulomb for TIP4P water w/out LJ * :doc:`tip4p/long/soft ` - From e8d9bf05075df7c7fdd12d28486d0d115a16aeb2 Mon Sep 17 00:00:00 2001 From: schererc Date: Wed, 1 Jun 2022 16:30:37 +0200 Subject: [PATCH 269/585] examples/PACKAGES: renamed pair_3b_table to pair_threebody_table including all input and documentation files --- .../1-1-1.table | 0 .../1-1-2.table | 0 .../CG-CG-CG.dist.new | 0 .../CG-CG.dist.new | 0 .../README | 30 +++++++++---------- .../calculate_distributions.xml | 0 .../run.sh | 0 .../spce.3b | 0 .../spce.data | 0 .../spce.in | 6 ++-- .../spce_2.3b | 0 .../spce_2.data | 0 .../spce_2.in | 6 ++-- .../table_CG_CG.txt | 0 14 files changed, 21 insertions(+), 21 deletions(-) rename examples/PACKAGES/{pair_3b_table => pair_threebody_table}/1-1-1.table (100%) rename examples/PACKAGES/{pair_3b_table => pair_threebody_table}/1-1-2.table (100%) rename examples/PACKAGES/{pair_3b_table => pair_threebody_table}/CG-CG-CG.dist.new (100%) rename examples/PACKAGES/{pair_3b_table => pair_threebody_table}/CG-CG.dist.new (100%) rename examples/PACKAGES/{pair_3b_table => pair_threebody_table}/README (66%) rename examples/PACKAGES/{pair_3b_table => pair_threebody_table}/calculate_distributions.xml (100%) rename examples/PACKAGES/{pair_3b_table => pair_threebody_table}/run.sh (100%) rename examples/PACKAGES/{pair_3b_table => pair_threebody_table}/spce.3b (100%) rename examples/PACKAGES/{pair_3b_table => pair_threebody_table}/spce.data (100%) rename examples/PACKAGES/{pair_3b_table => pair_threebody_table}/spce.in (83%) rename examples/PACKAGES/{pair_3b_table => pair_threebody_table}/spce_2.3b (100%) rename examples/PACKAGES/{pair_3b_table => pair_threebody_table}/spce_2.data (100%) rename examples/PACKAGES/{pair_3b_table => pair_threebody_table}/spce_2.in (82%) rename examples/PACKAGES/{pair_3b_table => pair_threebody_table}/table_CG_CG.txt (100%) diff --git a/examples/PACKAGES/pair_3b_table/1-1-1.table b/examples/PACKAGES/pair_threebody_table/1-1-1.table similarity index 100% rename from examples/PACKAGES/pair_3b_table/1-1-1.table rename to examples/PACKAGES/pair_threebody_table/1-1-1.table diff --git a/examples/PACKAGES/pair_3b_table/1-1-2.table b/examples/PACKAGES/pair_threebody_table/1-1-2.table similarity index 100% rename from examples/PACKAGES/pair_3b_table/1-1-2.table rename to examples/PACKAGES/pair_threebody_table/1-1-2.table diff --git a/examples/PACKAGES/pair_3b_table/CG-CG-CG.dist.new b/examples/PACKAGES/pair_threebody_table/CG-CG-CG.dist.new similarity index 100% rename from examples/PACKAGES/pair_3b_table/CG-CG-CG.dist.new rename to examples/PACKAGES/pair_threebody_table/CG-CG-CG.dist.new diff --git a/examples/PACKAGES/pair_3b_table/CG-CG.dist.new b/examples/PACKAGES/pair_threebody_table/CG-CG.dist.new similarity index 100% rename from examples/PACKAGES/pair_3b_table/CG-CG.dist.new rename to examples/PACKAGES/pair_threebody_table/CG-CG.dist.new diff --git a/examples/PACKAGES/pair_3b_table/README b/examples/PACKAGES/pair_threebody_table/README similarity index 66% rename from examples/PACKAGES/pair_3b_table/README rename to examples/PACKAGES/pair_threebody_table/README index d01c00afdd..3897f80a81 100644 --- a/examples/PACKAGES/pair_3b_table/README +++ b/examples/PACKAGES/pair_threebody_table/README @@ -1,10 +1,10 @@ -Example for pair style 3b/table +Example for pair style threebody/table This example contains all required input files for the simulation of CG SPC/E water with -the user pair style 3b/table, as well as a run.sh script. +the user pair style threebody/table, as well as a run.sh script. -To run the example, you have to compile LAMMPS with the MANYBODY package, including pair_3b_table.h and pair_3b_table.cpp. +To run the example, you have to compile LAMMPS with the MANYBODY package, including pair_threebody_table.h and pair_threebody_table.cpp. Running the simulations, you will reproduce results of the following publication: @@ -16,20 +16,20 @@ The three-body (force) tables for both parts (1-1-1.table and 1-1-2.table) have For a general description of the table format have a look at the documentation of this pair style. For a example on the parametrization, have a look at https://gitlab.mpcdf.mpg.de/votca/votca/-/tree/master/csg-examples/guide and https://gitlab.mpcdf.mpg.de/votca/votca/-/tree/master/csg-examples/ml. -In both cases, the parametrization has been done according to the three-body forces of the FM tabulated Stillinger-Weber (sw/3b/table) potential with the covariant meshing technique with the settings files used in https://gitlab.mpcdf.mpg.de/votca/votca/-/tree/master/csg-examples/ml/3body/with_binning. +In both cases, the parametrization is done according to a sample system, using the three-body forces of a Stillinger-Weber potential with tabulated angular forces (sw/angle/table). These then are learned with the covariant meshing technique with the settings files used in https://gitlab.mpcdf.mpg.de/votca/votca/-/tree/master/csg-examples/ml/3body/with_binning. -For the first part of example, the folder contains the contains the LAMMPS data file (spce.data) with the starting configuration of 1000 CG water molecules, an input file (spce.in) and a three-body file (spce.3b). +For the first part of example, the folder contains the contains the LAMMPS data file (spce.data) with the starting configuration of 1000 CG water molecules, an input file (spce.in) and a threebody file (spce.3b). The lammps input file contains the lines specifying the pair style and coefficients: -- pair_style hybrid/overlay table linear 1200 3b/table - use a combination of pair style table with 1200 linear table entries and the pair style 3b/table +- pair_style hybrid/overlay table linear 1200 threebody/table - use a combination of pair style table with 1200 linear table entries and the pair style threebody/table - pair_coeff 1 1 table table_CG_CG.txt VOTCA - set the table name and keyword for the pair style table -- pair_coeff * * 3b/table spce.3b type - set the name of 3body file and bead type for the pair style 3b/table +- pair_coeff * * threebody/table spce.3b type - set the name of threebody file and bead type for the pair style threebody/table -A hybrid pair style is used, where pair forces are calculated as a tabulated interaction (table_CG_CG.txt) and the pair style 3b/table is only used to calculate the three-body forces. -The tabulated pair interaction is the same as in the example of the sw/3b/table pair style: examples/PACKAGES/pair_sw_3b_table +A hybrid pair style is used, where pair forces are calculated as a tabulated interaction (table_CG_CG.txt) and the pair style threebody/table is only used to calculate the three-body forces. +The tabulated pair interaction is the same as in the example of the sw/angle/table pair style: examples/PACKAGES/pair_sw_angle_table -To run the simulation, one needs an additional 3body file (spce.3b). +To run the simulation, one needs an additional threebody file (spce.3b). It has the following structure: - type - relates to keyword type in LAMMPS input file @@ -46,18 +46,18 @@ As there is only one atom type (1), the force table is symmetric and contains "M The LAMMPS simulation is a standard nvt simulation. A dump file is output with the positions and forces every 10 time steps. You can calculate the pair distribution and compare it to the ones in the publication. -For the second part of the example, have a look at the LAMMPS data file (spce_2.data), the input file (spce_2.in) and the three-body file (spce_2.3b). +For the second part of the example, have a look at the LAMMPS data file (spce_2.data), the input file (spce_2.in) and the threebody file (spce_2.3b). Running the second part, you will in fact perform the same MD simulation as in the first part of the example. However, the atom type of the first 100 CG water molecules has been changed from 1 to 2. This is done to demonstrate how to run a simulation with different atom types. Again, lammps input file (spce_2.in) contains the lines specifying the pair style and coefficients: -- pair_style hybrid/overlay table linear 1200 3b/table - use a combination of pair style table with 1200 linear table entries and the pair style 3b/table +- pair_style hybrid/overlay table linear 1200 threebody/table - use a combination of pair style table with 1200 linear table entries and the pair style threebody/table - pair_coeff 1 1 table table_CG_CG.txt VOTCA - set the table name and keyword for the pair style table -- pair_coeff * * 3b/table spce_2.3b type1 type2 - set the name of 3body file and bead type for the pair style 3b/table +- pair_coeff * * threebody/table spce_2.3b type1 type2 - set the name of threebody file and bead type for the pair style threebody/table -Now, the atom type 1 is mapped to the element type1 and the atom type 2 is mapped to the element type2 in the 3body file (spce_2.3b). -For this (artificial) two-element simulation, the 3body file now contain 8 entries for: type1 type1 type1, type1 type1 type2, type1 type2 type1, type1 type2 type2, type2 type1 type1, type2 type1 type2, type2 type2 type1, type2 type2 type2. +Now, the atom type 1 is mapped to the element type1 and the atom type 2 is mapped to the element type2 in the threebody file (spce_2.3b). +For this (artificial) two-element simulation, the threebody file now contain 8 entries for: type1 type1 type1, type1 type1 type2, type1 type2 type1, type1 type2 type2, type2 type1 type1, type2 type1 type2, type2 type2 type1, type2 type2 type2. Each entry has the same structure as above. However, entries where the second and the third element are different require a different force table (1-1-2.table) instead of (1-1-1.table). 1-1-2.table contains exactly the force constants as 1-1-1.table. However it has to have the asymmetric structure where both interparticle distances (r_ij and r_ik) are varied from rmin to rmax and therefore contains "M = 2 * N * N * N" (2 * 12 * 12 * 12 = 3456) entries. diff --git a/examples/PACKAGES/pair_3b_table/calculate_distributions.xml b/examples/PACKAGES/pair_threebody_table/calculate_distributions.xml similarity index 100% rename from examples/PACKAGES/pair_3b_table/calculate_distributions.xml rename to examples/PACKAGES/pair_threebody_table/calculate_distributions.xml diff --git a/examples/PACKAGES/pair_3b_table/run.sh b/examples/PACKAGES/pair_threebody_table/run.sh similarity index 100% rename from examples/PACKAGES/pair_3b_table/run.sh rename to examples/PACKAGES/pair_threebody_table/run.sh diff --git a/examples/PACKAGES/pair_3b_table/spce.3b b/examples/PACKAGES/pair_threebody_table/spce.3b similarity index 100% rename from examples/PACKAGES/pair_3b_table/spce.3b rename to examples/PACKAGES/pair_threebody_table/spce.3b diff --git a/examples/PACKAGES/pair_3b_table/spce.data b/examples/PACKAGES/pair_threebody_table/spce.data similarity index 100% rename from examples/PACKAGES/pair_3b_table/spce.data rename to examples/PACKAGES/pair_threebody_table/spce.data diff --git a/examples/PACKAGES/pair_3b_table/spce.in b/examples/PACKAGES/pair_threebody_table/spce.in similarity index 83% rename from examples/PACKAGES/pair_3b_table/spce.in rename to examples/PACKAGES/pair_threebody_table/spce.in index c5b72c4f9a..2ca97708c6 100644 --- a/examples/PACKAGES/pair_3b_table/spce.in +++ b/examples/PACKAGES/pair_threebody_table/spce.in @@ -7,12 +7,12 @@ read_data spce.data #hybrid pair style consisting of #pair_style table to read in CG pair potential -#pair_style 3b/table for tabulated 3b interactions -pair_style hybrid/overlay table linear 1200 3b/table +#pair_style threebody/table for tabulated threebody interactions +pair_style hybrid/overlay table linear 1200 threebody/table #pair coefficients pair_coeff 1 1 table table_CG_CG.txt VOTCA -pair_coeff * * 3b/table spce.3b type +pair_coeff * * threebody/table spce.3b type #nvt run with nose-hoover thermostat #time coupling of 100 ts for thermostat diff --git a/examples/PACKAGES/pair_3b_table/spce_2.3b b/examples/PACKAGES/pair_threebody_table/spce_2.3b similarity index 100% rename from examples/PACKAGES/pair_3b_table/spce_2.3b rename to examples/PACKAGES/pair_threebody_table/spce_2.3b diff --git a/examples/PACKAGES/pair_3b_table/spce_2.data b/examples/PACKAGES/pair_threebody_table/spce_2.data similarity index 100% rename from examples/PACKAGES/pair_3b_table/spce_2.data rename to examples/PACKAGES/pair_threebody_table/spce_2.data diff --git a/examples/PACKAGES/pair_3b_table/spce_2.in b/examples/PACKAGES/pair_threebody_table/spce_2.in similarity index 82% rename from examples/PACKAGES/pair_3b_table/spce_2.in rename to examples/PACKAGES/pair_threebody_table/spce_2.in index 55db11b7cb..e05df5d719 100644 --- a/examples/PACKAGES/pair_3b_table/spce_2.in +++ b/examples/PACKAGES/pair_threebody_table/spce_2.in @@ -7,12 +7,12 @@ read_data spce_2.data #hybrid pair style consisting of #pair_style table to read in CG pair potential -#pair_style 3b/table for tabulated 3b interactions -pair_style hybrid/overlay table linear 1200 3b/table +#pair_style threebody/table for tabulated threebody interactions +pair_style hybrid/overlay table linear 1200 threebody/table #pair coefficients pair_coeff * * table table_CG_CG.txt VOTCA -pair_coeff * * 3b/table spce_2.3b type1 type2 +pair_coeff * * threebody/table spce_2.3b type1 type2 #nvt run with nose-hoover thermostat #time coupling of 100 ts for thermostat diff --git a/examples/PACKAGES/pair_3b_table/table_CG_CG.txt b/examples/PACKAGES/pair_threebody_table/table_CG_CG.txt similarity index 100% rename from examples/PACKAGES/pair_3b_table/table_CG_CG.txt rename to examples/PACKAGES/pair_threebody_table/table_CG_CG.txt From 95a979c657e3697884e15412e8c2cfcafe88442e Mon Sep 17 00:00:00 2001 From: schererc Date: Wed, 1 Jun 2022 16:34:10 +0200 Subject: [PATCH 270/585] examples/PACKAGES: rename pair_sw_3b_table to pair_sw_angle_table including all input and documentation files --- .../{pair_sw_3b_table => pair_sw_angle_table}/README | 12 ++++++------ .../{pair_sw_3b_table => pair_sw_angle_table}/run.sh | 0 .../spce.data | 0 .../spce.in | 6 +++--- .../spce.sw | 0 .../table_CG_CG.txt | 0 .../table_CG_CG_CG.txt | 0 7 files changed, 9 insertions(+), 9 deletions(-) rename examples/PACKAGES/{pair_sw_3b_table => pair_sw_angle_table}/README (80%) rename examples/PACKAGES/{pair_sw_3b_table => pair_sw_angle_table}/run.sh (100%) rename examples/PACKAGES/{pair_sw_3b_table => pair_sw_angle_table}/spce.data (100%) rename examples/PACKAGES/{pair_sw_3b_table => pair_sw_angle_table}/spce.in (82%) rename examples/PACKAGES/{pair_sw_3b_table => pair_sw_angle_table}/spce.sw (100%) rename examples/PACKAGES/{pair_sw_3b_table => pair_sw_angle_table}/table_CG_CG.txt (100%) rename examples/PACKAGES/{pair_sw_3b_table => pair_sw_angle_table}/table_CG_CG_CG.txt (100%) diff --git a/examples/PACKAGES/pair_sw_3b_table/README b/examples/PACKAGES/pair_sw_angle_table/README similarity index 80% rename from examples/PACKAGES/pair_sw_3b_table/README rename to examples/PACKAGES/pair_sw_angle_table/README index 2d00030fea..54e665ff6c 100644 --- a/examples/PACKAGES/pair_sw_3b_table/README +++ b/examples/PACKAGES/pair_sw_angle_table/README @@ -1,10 +1,10 @@ -Example for pair style sw/3b/table +Example for pair style sw/angle/table This example contains all required input files for the simulation of CG SPC/E water with -the user pair style sw/3b/table, as well as a run.sh script. +the user pair style sw/angle/table, as well as a run.sh script. -To run the example, you have to compile LAMMPS with the MANYBODY package, including pair_sw_3b_table.h and pair_sw_3b_table.cpp. +To run the example, you have to compile LAMMPS with the MANYBODY package, including pair_sw_angle_table.h and pair_sw_angle_table.cpp. Running the simulation, you will reproduce results of the following publication: @@ -22,11 +22,11 @@ of 1000 CG water molecules, an input file (spce.in) and a (modified) Stillinger- The lammps input file contains the lines specifying the pair style and coefficients: -- pair_style hybrid/overlay table linear 1200 sw/3b/table - use a combination of pair style table with 1200 linear table entries and the pair style sw/3b/table +- pair_style hybrid/overlay table linear 1200 sw/angle/table - use a combination of pair style table with 1200 linear table entries and the pair style sw/angle/table - pair_coeff 1 1 table table_CG_CG.txt VOTCA - set the table name and keyword for the pair_style table -- pair_coeff * * sw/3b/table spce.sw type - set the name of the Stillinger-Weber file for the pair style sw/3b/table +- pair_coeff * * sw/angle/table spce.sw type - set the name of the Stillinger-Weber file for the pair style sw/angle/table -A hybrid pair style is used, where pair forces are calculated as a tabulated interaction (table_CG_CG.txt) and the pair style sw/3b/table is only used to calculate the three-body forces. +A hybrid pair style is used, where pair forces are calculated as a tabulated interaction (table_CG_CG.txt) and the pair style sw/angle/table is only used to calculate the three-body forces. Therefore, in the Stillinger-Weber file all parameters refering to two-body interactions are set to zero. As explained in the documentation of this pair style, the .sw file contains the additional lines refering to the tabulated angular potential: diff --git a/examples/PACKAGES/pair_sw_3b_table/run.sh b/examples/PACKAGES/pair_sw_angle_table/run.sh similarity index 100% rename from examples/PACKAGES/pair_sw_3b_table/run.sh rename to examples/PACKAGES/pair_sw_angle_table/run.sh diff --git a/examples/PACKAGES/pair_sw_3b_table/spce.data b/examples/PACKAGES/pair_sw_angle_table/spce.data similarity index 100% rename from examples/PACKAGES/pair_sw_3b_table/spce.data rename to examples/PACKAGES/pair_sw_angle_table/spce.data diff --git a/examples/PACKAGES/pair_sw_3b_table/spce.in b/examples/PACKAGES/pair_sw_angle_table/spce.in similarity index 82% rename from examples/PACKAGES/pair_sw_3b_table/spce.in rename to examples/PACKAGES/pair_sw_angle_table/spce.in index 85303bf0d1..8b1ef719a6 100644 --- a/examples/PACKAGES/pair_sw_3b_table/spce.in +++ b/examples/PACKAGES/pair_sw_angle_table/spce.in @@ -9,12 +9,12 @@ read_data spce.data #hybrid pair style consisting of #pair_style table to read in CG pair potential -#pair_style sw/table for tabulated sw interactions -pair_style hybrid/overlay table linear 1200 sw/3b/table +#pair_style sw/angle/table for sw interactions with tabulated angular potential +pair_style hybrid/overlay table linear 1200 sw/angle/table #pair coefficients pair_coeff 1 1 table table_CG_CG.txt VOTCA -pair_coeff * * sw/3b/table spce.sw type +pair_coeff * * sw/angle/table spce.sw type #nvt run with nose-hoover thermostat #time coupling of 100 ts for thermostat diff --git a/examples/PACKAGES/pair_sw_3b_table/spce.sw b/examples/PACKAGES/pair_sw_angle_table/spce.sw similarity index 100% rename from examples/PACKAGES/pair_sw_3b_table/spce.sw rename to examples/PACKAGES/pair_sw_angle_table/spce.sw diff --git a/examples/PACKAGES/pair_sw_3b_table/table_CG_CG.txt b/examples/PACKAGES/pair_sw_angle_table/table_CG_CG.txt similarity index 100% rename from examples/PACKAGES/pair_sw_3b_table/table_CG_CG.txt rename to examples/PACKAGES/pair_sw_angle_table/table_CG_CG.txt diff --git a/examples/PACKAGES/pair_sw_3b_table/table_CG_CG_CG.txt b/examples/PACKAGES/pair_sw_angle_table/table_CG_CG_CG.txt similarity index 100% rename from examples/PACKAGES/pair_sw_3b_table/table_CG_CG_CG.txt rename to examples/PACKAGES/pair_sw_angle_table/table_CG_CG_CG.txt From b85b3e1f4c7969548726c2440bb43bc9ffb0218b Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 1 Jun 2022 12:06:56 -0400 Subject: [PATCH 271/585] fix doc file names and links --- doc/src/{pair_3b_table.rst => pair_threebody_table.rst} | 5 ++--- 1 file changed, 2 insertions(+), 3 deletions(-) rename doc/src/{pair_3b_table.rst => pair_threebody_table.rst} (98%) diff --git a/doc/src/pair_3b_table.rst b/doc/src/pair_threebody_table.rst similarity index 98% rename from doc/src/pair_3b_table.rst rename to doc/src/pair_threebody_table.rst index 569979f78d..5e2503fc3f 100644 --- a/doc/src/pair_3b_table.rst +++ b/doc/src/pair_threebody_table.rst @@ -29,9 +29,8 @@ Description The *threebody/table* style is a pair style for generic tabulated three-body interactions. It has been developed for (coarse-grained) simulations (of water) with Kernel-based machine learning (ML) potentials -(:ref:`Scherer2 `). As for the pair style :doc:`pair_style sw -` or :doc:`pair_style sw/threebody/table `, the energy of -a system is computed as a sum over three-body terms: +(:ref:`Scherer2 `). As for many other MANYBODY package pair styles +the energy of a system is computed as a sum over three-body terms: .. math:: From 8e9071b01f00c44d41060e08d3ceb234e9ccdd47 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 1 Jun 2022 14:22:53 -0400 Subject: [PATCH 272/585] move and update threebody/table examples --- doc/utils/sphinx-config/false_positives.txt | 1 + .../1-1-1.table | 0 .../1-1-2.table | 0 .../README | 0 .../spce.data => manybody_table/data.spce} | 0 .../spce_2.data => manybody_table/data.spce2} | 0 examples/PACKAGES/manybody_table/in.spce | 21 ++ examples/PACKAGES/manybody_table/in.spce2 | 22 ++ .../manybody_table/log.1Jun22.spce.g++.1 | 88 +++++ .../manybody_table/log.1Jun22.spce.g++.4 | 88 +++++ .../manybody_table/log.1Jun22.spce2.g++.1 | 89 ++++++ .../manybody_table/log.1Jun22.spce2.g++.4 | 89 ++++++ .../spce.3b | 0 .../spce_2.3b => manybody_table/spce2.3b} | 0 .../table_CG_CG.txt | 0 .../pair_threebody_table/CG-CG-CG.dist.new | 63 ---- .../pair_threebody_table/CG-CG.dist.new | 301 ------------------ .../calculate_distributions.xml | 29 -- examples/PACKAGES/pair_threebody_table/run.sh | 8 - .../PACKAGES/pair_threebody_table/spce.in | 43 --- .../PACKAGES/pair_threebody_table/spce_2.in | 43 --- 21 files changed, 398 insertions(+), 487 deletions(-) rename examples/PACKAGES/{pair_threebody_table => manybody_table}/1-1-1.table (100%) rename examples/PACKAGES/{pair_threebody_table => manybody_table}/1-1-2.table (100%) rename examples/PACKAGES/{pair_threebody_table => manybody_table}/README (100%) rename examples/PACKAGES/{pair_threebody_table/spce.data => manybody_table/data.spce} (100%) rename examples/PACKAGES/{pair_threebody_table/spce_2.data => manybody_table/data.spce2} (100%) create mode 100644 examples/PACKAGES/manybody_table/in.spce create mode 100644 examples/PACKAGES/manybody_table/in.spce2 create mode 100644 examples/PACKAGES/manybody_table/log.1Jun22.spce.g++.1 create mode 100644 examples/PACKAGES/manybody_table/log.1Jun22.spce.g++.4 create mode 100644 examples/PACKAGES/manybody_table/log.1Jun22.spce2.g++.1 create mode 100644 examples/PACKAGES/manybody_table/log.1Jun22.spce2.g++.4 rename examples/PACKAGES/{pair_threebody_table => manybody_table}/spce.3b (100%) rename examples/PACKAGES/{pair_threebody_table/spce_2.3b => manybody_table/spce2.3b} (100%) rename examples/PACKAGES/{pair_threebody_table => manybody_table}/table_CG_CG.txt (100%) delete mode 100644 examples/PACKAGES/pair_threebody_table/CG-CG-CG.dist.new delete mode 100644 examples/PACKAGES/pair_threebody_table/CG-CG.dist.new delete mode 100644 examples/PACKAGES/pair_threebody_table/calculate_distributions.xml delete mode 100755 examples/PACKAGES/pair_threebody_table/run.sh delete mode 100644 examples/PACKAGES/pair_threebody_table/spce.in delete mode 100644 examples/PACKAGES/pair_threebody_table/spce_2.in diff --git a/doc/utils/sphinx-config/false_positives.txt b/doc/utils/sphinx-config/false_positives.txt index 36efbe5e45..667d988433 100644 --- a/doc/utils/sphinx-config/false_positives.txt +++ b/doc/utils/sphinx-config/false_positives.txt @@ -3220,6 +3220,7 @@ statvolt stdin stdio stdlib +stdout steelblue Stegailov Steinbach diff --git a/examples/PACKAGES/pair_threebody_table/1-1-1.table b/examples/PACKAGES/manybody_table/1-1-1.table similarity index 100% rename from examples/PACKAGES/pair_threebody_table/1-1-1.table rename to examples/PACKAGES/manybody_table/1-1-1.table diff --git a/examples/PACKAGES/pair_threebody_table/1-1-2.table b/examples/PACKAGES/manybody_table/1-1-2.table similarity index 100% rename from examples/PACKAGES/pair_threebody_table/1-1-2.table rename to examples/PACKAGES/manybody_table/1-1-2.table diff --git a/examples/PACKAGES/pair_threebody_table/README b/examples/PACKAGES/manybody_table/README similarity index 100% rename from examples/PACKAGES/pair_threebody_table/README rename to examples/PACKAGES/manybody_table/README diff --git a/examples/PACKAGES/pair_threebody_table/spce.data b/examples/PACKAGES/manybody_table/data.spce similarity index 100% rename from examples/PACKAGES/pair_threebody_table/spce.data rename to examples/PACKAGES/manybody_table/data.spce diff --git a/examples/PACKAGES/pair_threebody_table/spce_2.data b/examples/PACKAGES/manybody_table/data.spce2 similarity index 100% rename from examples/PACKAGES/pair_threebody_table/spce_2.data rename to examples/PACKAGES/manybody_table/data.spce2 diff --git a/examples/PACKAGES/manybody_table/in.spce b/examples/PACKAGES/manybody_table/in.spce new file mode 100644 index 0000000000..6c6c6f2050 --- /dev/null +++ b/examples/PACKAGES/manybody_table/in.spce @@ -0,0 +1,21 @@ +units real +atom_style atomic + +# data file with one atom type +read_data data.spce + +pair_style hybrid/overlay table linear 1200 threebody/table + +#pair coefficients +pair_coeff 1 1 table table_CG_CG.txt VOTCA +pair_coeff * * threebody/table spce.3b type + +fix 1 all nvt temp 300.0 300.0 200.0 + +velocity all create 300 432567 dist uniform loop geom mom yes +timestep 2.0 + +thermo 100 +#dump 2 all custom 100 dump.spce id type x y z fx fy fz + +run 1000 diff --git a/examples/PACKAGES/manybody_table/in.spce2 b/examples/PACKAGES/manybody_table/in.spce2 new file mode 100644 index 0000000000..c8656c105f --- /dev/null +++ b/examples/PACKAGES/manybody_table/in.spce2 @@ -0,0 +1,22 @@ +units real +atom_style atomic + +# data file with two atom types +read_data data.spce2 + +pair_style hybrid/overlay table linear 1200 threebody/table + +#pair coefficients +pair_coeff * * table table_CG_CG.txt VOTCA +pair_coeff * * threebody/table spce2.3b type1 type2 + +fix 1 all nvt temp 300.0 300.0 200.0 + +velocity all create 300 432567 dist uniform loop geom mom yes +timestep 2.0 + +thermo 100 +#dump 2 all custom 100 dump.spce2 id type x y z fx fy fz + +run 1000 + diff --git a/examples/PACKAGES/manybody_table/log.1Jun22.spce.g++.1 b/examples/PACKAGES/manybody_table/log.1Jun22.spce.g++.1 new file mode 100644 index 0000000000..3489ad5d7a --- /dev/null +++ b/examples/PACKAGES/manybody_table/log.1Jun22.spce.g++.1 @@ -0,0 +1,88 @@ +LAMMPS (4 May 2022) + using 1 OpenMP thread(s) per MPI task +units real +atom_style atomic + +# data file with one atom type +read_data data.spce +Reading data file ... + orthogonal box = (0 0 0) to (31.0648 31.0648 31.0648) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 1000 atoms + read_data CPU = 0.001 seconds + +pair_style hybrid/overlay table linear 1200 threebody/table + +#pair coefficients +pair_coeff 1 1 table table_CG_CG.txt VOTCA +pair_coeff * * threebody/table spce.3b type + +fix 1 all nvt temp 300.0 300.0 200.0 + +velocity all create 300 432567 dist uniform loop geom mom yes +timestep 2.0 + +thermo 100 +#dump 2 all custom 100 dump.spce id type x y z fx fy fz + +run 1000 +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 14 + ghost atom cutoff = 14 + binsize = 7, bins = 5 5 5 + 2 neighbor lists, perpetual/occasional/extra = 2 0 0 + (1) pair table, perpetual, half/full from (2) + attributes: half, newton on + pair build: halffull/newton + stencil: none + bin: none + (2) pair threebody/table, perpetual + attributes: full, newton on + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 5.487 | 5.487 | 5.487 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 300 -5377.8719 0 -4484.5232 -320.10184 + 100 296.01121 -5418.505 0 -4537.0342 -223.39972 + 200 295.27654 -5430.3033 0 -4551.0202 794.29126 + 300 302.16526 -5445.8048 0 -4546.0083 -11.568299 + 400 308.59003 -5434.7181 0 -4515.7896 1.7337645 + 500 295.346 -5436.0896 0 -4556.5996 778.73307 + 600 293.14671 -5422.6082 0 -4549.6673 -148.64256 + 700 307.63238 -5465.187 0 -4549.1103 285.18556 + 800 313.16537 -5466.4124 0 -4533.8594 489.99301 + 900 303.42954 -5506.3208 0 -4602.7595 360.05608 + 1000 299.50926 -5446.8981 0 -4555.0107 993.95615 +Loop time of 5.12079 on 1 procs for 1000 steps with 1000 atoms + +Performance: 33.745 ns/day, 0.711 hours/ns, 195.282 timesteps/s +99.7% CPU use with 1 MPI tasks x 1 OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 4.8109 | 4.8109 | 4.8109 | 0.0 | 93.95 +Neigh | 0.27061 | 0.27061 | 0.27061 | 0.0 | 5.28 +Comm | 0.020092 | 0.020092 | 0.020092 | 0.0 | 0.39 +Output | 0.00020325 | 0.00020325 | 0.00020325 | 0.0 | 0.00 +Modify | 0.011643 | 0.011643 | 0.011643 | 0.0 | 0.23 +Other | | 0.007324 | | | 0.14 + +Nlocal: 1000 ave 1000 max 1000 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 5900 ave 5900 max 5900 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 191126 ave 191126 max 191126 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +FullNghs: 382252 ave 382252 max 382252 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 382252 +Ave neighs/atom = 382.252 +Neighbor list builds = 27 +Dangerous builds = 0 +Total wall time: 0:00:05 diff --git a/examples/PACKAGES/manybody_table/log.1Jun22.spce.g++.4 b/examples/PACKAGES/manybody_table/log.1Jun22.spce.g++.4 new file mode 100644 index 0000000000..e5985ae51e --- /dev/null +++ b/examples/PACKAGES/manybody_table/log.1Jun22.spce.g++.4 @@ -0,0 +1,88 @@ +LAMMPS (4 May 2022) + using 1 OpenMP thread(s) per MPI task +units real +atom_style atomic + +# data file with one atom type +read_data data.spce +Reading data file ... + orthogonal box = (0 0 0) to (31.0648 31.0648 31.0648) + 1 by 2 by 2 MPI processor grid + reading atoms ... + 1000 atoms + read_data CPU = 0.001 seconds + +pair_style hybrid/overlay table linear 1200 threebody/table + +#pair coefficients +pair_coeff 1 1 table table_CG_CG.txt VOTCA +pair_coeff * * threebody/table spce.3b type + +fix 1 all nvt temp 300.0 300.0 200.0 + +velocity all create 300 432567 dist uniform loop geom mom yes +timestep 2.0 + +thermo 100 +#dump 2 all custom 100 dump.spce id type x y z fx fy fz + +run 1000 +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 14 + ghost atom cutoff = 14 + binsize = 7, bins = 5 5 5 + 2 neighbor lists, perpetual/occasional/extra = 2 0 0 + (1) pair table, perpetual, half/full from (2) + attributes: half, newton on + pair build: halffull/newton + stencil: none + bin: none + (2) pair threebody/table, perpetual + attributes: full, newton on + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 3.87 | 3.87 | 3.87 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 300 -5377.8719 0 -4484.5232 -320.10184 + 100 296.01121 -5418.505 0 -4537.0342 -223.39972 + 200 295.27654 -5430.3033 0 -4551.0202 794.29126 + 300 302.16526 -5445.8048 0 -4546.0083 -11.568299 + 400 308.59003 -5434.7181 0 -4515.7896 1.7337642 + 500 295.346 -5436.0896 0 -4556.5996 778.73304 + 600 293.14648 -5422.6082 0 -4549.6681 -148.67071 + 700 307.6975 -5465.3018 0 -4549.0312 287.70203 + 800 314.09436 -5467.6073 0 -4532.2879 522.73489 + 900 300.85843 -5503.7551 0 -4607.85 491.78041 + 1000 302.84638 -5468.3331 0 -4566.5083 338.05123 +Loop time of 1.45119 on 4 procs for 1000 steps with 1000 atoms + +Performance: 119.075 ns/day, 0.202 hours/ns, 689.091 timesteps/s +98.3% CPU use with 4 MPI tasks x 1 OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 1.2376 | 1.256 | 1.2833 | 1.5 | 86.55 +Neigh | 0.06865 | 0.06984 | 0.071283 | 0.4 | 4.81 +Comm | 0.084664 | 0.1133 | 0.13329 | 5.4 | 7.81 +Output | 0.0001668 | 0.00034177 | 0.00086454 | 0.0 | 0.02 +Modify | 0.0069024 | 0.0071705 | 0.0074503 | 0.3 | 0.49 +Other | | 0.004489 | | | 0.31 + +Nlocal: 250 ave 257 max 240 min +Histogram: 1 0 0 0 0 1 0 0 1 1 +Nghost: 3488.75 ave 3504 max 3478 min +Histogram: 1 1 0 0 0 1 0 0 0 1 +Neighs: 47828 ave 49169 max 45782 min +Histogram: 1 0 0 0 0 1 0 0 1 1 +FullNghs: 95656 ave 98253 max 91425 min +Histogram: 1 0 0 0 0 1 0 0 1 1 + +Total # of neighbors = 382624 +Ave neighs/atom = 382.624 +Neighbor list builds = 27 +Dangerous builds = 0 +Total wall time: 0:00:01 diff --git a/examples/PACKAGES/manybody_table/log.1Jun22.spce2.g++.1 b/examples/PACKAGES/manybody_table/log.1Jun22.spce2.g++.1 new file mode 100644 index 0000000000..12503118e0 --- /dev/null +++ b/examples/PACKAGES/manybody_table/log.1Jun22.spce2.g++.1 @@ -0,0 +1,89 @@ +LAMMPS (4 May 2022) + using 1 OpenMP thread(s) per MPI task +units real +atom_style atomic + +# data file with two atom types +read_data data.spce2 +Reading data file ... + orthogonal box = (0 0 0) to (31.0648 31.0648 31.0648) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 1000 atoms + read_data CPU = 0.001 seconds + +pair_style hybrid/overlay table linear 1200 threebody/table + +#pair coefficients +pair_coeff * * table table_CG_CG.txt VOTCA +pair_coeff * * threebody/table spce2.3b type1 type2 + +fix 1 all nvt temp 300.0 300.0 200.0 + +velocity all create 300 432567 dist uniform loop geom mom yes +timestep 2.0 + +thermo 100 +#dump 2 all custom 100 dump.spce2 id type x y z fx fy fz + +run 1000 +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 14 + ghost atom cutoff = 14 + binsize = 7, bins = 5 5 5 + 2 neighbor lists, perpetual/occasional/extra = 2 0 0 + (1) pair table, perpetual, half/full from (2) + attributes: half, newton on + pair build: halffull/newton + stencil: none + bin: none + (2) pair threebody/table, perpetual + attributes: full, newton on + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 5.487 | 5.487 | 5.487 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 300 -5377.8719 0 -4484.5232 -320.10184 + 100 296.01121 -5418.505 0 -4537.0342 -223.39972 + 200 295.27654 -5430.3033 0 -4551.0202 794.29126 + 300 302.16526 -5445.8048 0 -4546.0083 -11.568299 + 400 308.59003 -5434.7181 0 -4515.7896 1.7337645 + 500 295.346 -5436.0896 0 -4556.5996 778.73307 + 600 293.14671 -5422.6082 0 -4549.6673 -148.64256 + 700 307.63238 -5465.187 0 -4549.1103 285.18556 + 800 313.16537 -5466.4124 0 -4533.8594 489.99301 + 900 303.42954 -5506.3208 0 -4602.7595 360.05608 + 1000 299.50926 -5446.8981 0 -4555.0107 993.95615 +Loop time of 5.16704 on 1 procs for 1000 steps with 1000 atoms + +Performance: 33.443 ns/day, 0.718 hours/ns, 193.534 timesteps/s +99.7% CPU use with 1 MPI tasks x 1 OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 4.8574 | 4.8574 | 4.8574 | 0.0 | 94.01 +Neigh | 0.27015 | 0.27015 | 0.27015 | 0.0 | 5.23 +Comm | 0.020112 | 0.020112 | 0.020112 | 0.0 | 0.39 +Output | 0.0002118 | 0.0002118 | 0.0002118 | 0.0 | 0.00 +Modify | 0.011792 | 0.011792 | 0.011792 | 0.0 | 0.23 +Other | | 0.007409 | | | 0.14 + +Nlocal: 1000 ave 1000 max 1000 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 5900 ave 5900 max 5900 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 191126 ave 191126 max 191126 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +FullNghs: 382252 ave 382252 max 382252 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 382252 +Ave neighs/atom = 382.252 +Neighbor list builds = 27 +Dangerous builds = 0 + +Total wall time: 0:00:05 diff --git a/examples/PACKAGES/manybody_table/log.1Jun22.spce2.g++.4 b/examples/PACKAGES/manybody_table/log.1Jun22.spce2.g++.4 new file mode 100644 index 0000000000..23f3348c34 --- /dev/null +++ b/examples/PACKAGES/manybody_table/log.1Jun22.spce2.g++.4 @@ -0,0 +1,89 @@ +LAMMPS (4 May 2022) + using 1 OpenMP thread(s) per MPI task +units real +atom_style atomic + +# data file with two atom types +read_data data.spce2 +Reading data file ... + orthogonal box = (0 0 0) to (31.0648 31.0648 31.0648) + 1 by 2 by 2 MPI processor grid + reading atoms ... + 1000 atoms + read_data CPU = 0.002 seconds + +pair_style hybrid/overlay table linear 1200 threebody/table + +#pair coefficients +pair_coeff * * table table_CG_CG.txt VOTCA +pair_coeff * * threebody/table spce2.3b type1 type2 + +fix 1 all nvt temp 300.0 300.0 200.0 + +velocity all create 300 432567 dist uniform loop geom mom yes +timestep 2.0 + +thermo 100 +#dump 2 all custom 100 dump.spce2 id type x y z fx fy fz + +run 1000 +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 14 + ghost atom cutoff = 14 + binsize = 7, bins = 5 5 5 + 2 neighbor lists, perpetual/occasional/extra = 2 0 0 + (1) pair table, perpetual, half/full from (2) + attributes: half, newton on + pair build: halffull/newton + stencil: none + bin: none + (2) pair threebody/table, perpetual + attributes: full, newton on + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 3.87 | 3.87 | 3.87 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 300 -5377.8719 0 -4484.5232 -320.10184 + 100 296.01121 -5418.505 0 -4537.0342 -223.39972 + 200 295.27654 -5430.3033 0 -4551.0202 794.29126 + 300 302.16526 -5445.8048 0 -4546.0083 -11.568299 + 400 308.59003 -5434.7181 0 -4515.7896 1.7337642 + 500 295.346 -5436.0896 0 -4556.5996 778.73304 + 600 293.14648 -5422.6082 0 -4549.6681 -148.67071 + 700 307.6975 -5465.3018 0 -4549.0312 287.70203 + 800 314.09436 -5467.6073 0 -4532.2879 522.73489 + 900 300.85843 -5503.7551 0 -4607.85 491.78041 + 1000 302.84638 -5468.3331 0 -4566.5083 338.05123 +Loop time of 1.4686 on 4 procs for 1000 steps with 1000 atoms + +Performance: 117.663 ns/day, 0.204 hours/ns, 680.919 timesteps/s +98.1% CPU use with 4 MPI tasks x 1 OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 1.2491 | 1.2757 | 1.3162 | 2.3 | 86.87 +Neigh | 0.06817 | 0.069468 | 0.071025 | 0.5 | 4.73 +Comm | 0.069929 | 0.11236 | 0.14069 | 8.1 | 7.65 +Output | 0.00016417 | 0.00050711 | 0.0015318 | 0.0 | 0.03 +Modify | 0.0057514 | 0.0061681 | 0.0066503 | 0.5 | 0.42 +Other | | 0.004366 | | | 0.30 + +Nlocal: 250 ave 257 max 240 min +Histogram: 1 0 0 0 0 1 0 0 1 1 +Nghost: 3488.75 ave 3504 max 3478 min +Histogram: 1 1 0 0 0 1 0 0 0 1 +Neighs: 47828 ave 49169 max 45782 min +Histogram: 1 0 0 0 0 1 0 0 1 1 +FullNghs: 95656 ave 98253 max 91425 min +Histogram: 1 0 0 0 0 1 0 0 1 1 + +Total # of neighbors = 382624 +Ave neighs/atom = 382.624 +Neighbor list builds = 27 +Dangerous builds = 0 + +Total wall time: 0:00:01 diff --git a/examples/PACKAGES/pair_threebody_table/spce.3b b/examples/PACKAGES/manybody_table/spce.3b similarity index 100% rename from examples/PACKAGES/pair_threebody_table/spce.3b rename to examples/PACKAGES/manybody_table/spce.3b diff --git a/examples/PACKAGES/pair_threebody_table/spce_2.3b b/examples/PACKAGES/manybody_table/spce2.3b similarity index 100% rename from examples/PACKAGES/pair_threebody_table/spce_2.3b rename to examples/PACKAGES/manybody_table/spce2.3b diff --git a/examples/PACKAGES/pair_threebody_table/table_CG_CG.txt b/examples/PACKAGES/manybody_table/table_CG_CG.txt similarity index 100% rename from examples/PACKAGES/pair_threebody_table/table_CG_CG.txt rename to examples/PACKAGES/manybody_table/table_CG_CG.txt diff --git a/examples/PACKAGES/pair_threebody_table/CG-CG-CG.dist.new b/examples/PACKAGES/pair_threebody_table/CG-CG-CG.dist.new deleted file mode 100644 index 7009d77ec6..0000000000 --- a/examples/PACKAGES/pair_threebody_table/CG-CG-CG.dist.new +++ /dev/null @@ -1,63 +0,0 @@ -0 0 i -0.05 0 i -0.1 0 i -0.15 0 i -0.2 0 i -0.25 0 i -0.3 0 i -0.35 0 i -0.4 0 i -0.45 0 i -0.5 0 i -0.55 0 i -0.6 0 i -0.65 0 i -0.7 0.001948589708 i -0.75 0.04587304938 i -0.8 0.2676063199 i -0.85 0.5482844291 i -0.9 0.6484744166 i -0.95 0.6004903951 i -1 0.4988389653 i -1.05 0.4309630905 i -1.1 0.4329116802 i -1.15 0.4468765731 i -1.2 0.4768361398 i -1.25 0.4997320689 i -1.3 0.5256320738 i -1.35 0.5270935161 i -1.4 0.5542925807 i -1.45 0.5859571635 i -1.5 0.5850640599 i -1.55 0.5951317734 i -1.6 0.6080411802 i -1.65 0.6103145349 i -1.7 0.6252537226 i -1.75 0.6264715912 i -1.8 0.6312618742 i -1.85 0.6111264472 i -1.9 0.5870938408 i -1.95 0.5864443109 i -2 0.5615186009 i -2.05 0.5516944611 i -2.1 0.5181624799 i -2.15 0.5016806586 i -2.2 0.4791906857 i -2.25 0.4356721823 i -2.3 0.4166734326 i -2.35 0.4014906711 i -2.4 0.3701508533 i -2.45 0.3518016336 i -2.5 0.32533329 i -2.55 0.3129922219 i -2.6 0.2849812448 i -2.65 0.2464965981 i -2.7 0.2347238686 i -2.75 0.1968887518 i -2.8 0.1679846711 i -2.85 0.1487423477 i -2.9 0.115372749 i -2.95 0.0894727441 i -3 0.0654401377 i -3.05 0.04424922462 i -3.1 0.02127210431 i diff --git a/examples/PACKAGES/pair_threebody_table/CG-CG.dist.new b/examples/PACKAGES/pair_threebody_table/CG-CG.dist.new deleted file mode 100644 index 20086f12e2..0000000000 --- a/examples/PACKAGES/pair_threebody_table/CG-CG.dist.new +++ /dev/null @@ -1,301 +0,0 @@ -0 0 i -0.05 0 i -0.1 0 i -0.15 0 i -0.2 0 i -0.25 0 i -0.3 0 i -0.35 0 i -0.4 0 i -0.45 0 i -0.5 0 i -0.55 0 i -0.6 0 i -0.65 0 i -0.7 0 i -0.75 0 i -0.8 0 i -0.85 0 i -0.9 0 i -0.95 0 i -1 0 i -1.05 0 i -1.1 0 i -1.15 0 i -1.2 0 i -1.25 0 i -1.3 0 i -1.35 0 i -1.4 0 i -1.45 0 i -1.5 0 i -1.55 0 i -1.6 0 i -1.65 0 i -1.7 0 i -1.75 0 i -1.8 0 i -1.85 0 i -1.9 0 i -1.95 0 i -2 0 i -2.05 0 i -2.1 0 i -2.15 0 i -2.2 0 i -2.25 0 i -2.3 0 i -2.35 0 i -2.4 0 i -2.45 0.006868969636 i -2.5 0.06691209899 i -2.55 0.3369686231 i -2.6 1.016837547 i -2.65 1.941722496 i -2.7 2.810156047 i -2.75 3.109238091 i -2.8 2.992426567 i -2.85 2.654848044 i -2.9 2.142463942 i -2.95 1.78347485 i -3 1.474515791 i -3.05 1.214450999 i -3.1 1.145558566 i -3.15 1.05605496 i -3.2 0.9416308652 i -3.25 0.9061891875 i -3.3 0.8518932332 i -3.35 0.8345267201 i -3.4 0.7974243251 i -3.45 0.7759630924 i -3.5 0.8025159274 i -3.55 0.7814715757 i -3.6 0.8367247283 i -3.65 0.8466756241 i -3.7 0.8260987595 i -3.75 0.8875703499 i -3.8 0.8908815678 i -3.85 0.8893512455 i -3.9 0.9034838101 i -3.95 0.975136055 i -4 0.9693174253 i -4.05 0.9333220268 i -4.1 0.9786753242 i -4.15 1.02432124 i -4.2 0.9877232079 i -4.25 1.042558817 i -4.3 1.016224537 i -4.35 1.041869238 i -4.4 1.064875454 i -4.45 1.028884843 i -4.5 1.030581768 i -4.55 1.048458215 i -4.6 1.089257872 i -4.65 1.094290276 i -4.7 1.084997348 i -4.75 1.070629827 i -4.8 1.084744429 i -4.85 1.082526933 i -4.9 1.06079278 i -4.95 1.0471637 i -5 1.062609545 i -5.05 1.040979202 i -5.1 1.030405966 i -5.15 1.010273278 i -5.2 1.023613984 i -5.25 0.9909597269 i -5.3 1.015757348 i -5.35 1.006532346 i -5.4 0.9437414066 i -5.45 0.961407175 i -5.5 0.9391385986 i -5.55 0.9337672098 i -5.6 0.9434633573 i -5.65 0.9427075195 i -5.7 0.9256975468 i -5.75 0.969172923 i -5.8 0.9108617596 i -5.85 0.9316750162 i -5.9 0.9343951559 i -5.95 0.9320676092 i -6 0.9648657983 i -6.05 0.9452822858 i -6.1 0.9782890038 i -6.15 0.9800447499 i -6.2 1.000311384 i -6.25 0.9763785285 i -6.3 1.003683553 i -6.35 0.9945134274 i -6.4 1.018437926 i -6.45 1.022248288 i -6.5 1.016480477 i -6.55 1.022988268 i -6.6 1.012956154 i -6.65 1.03627509 i -6.7 1.053539045 i -6.75 1.033851978 i -6.8 1.030805888 i -6.85 1.025729717 i -6.9 1.050384748 i -6.95 1.025204169 i -7 1.032609309 i -7.05 1.03922794 i -7.1 1.029667001 i -7.15 1.034097295 i -7.2 0.9966052515 i -7.25 0.998595277 i -7.3 1.020333466 i -7.35 1.012277485 i -7.4 1.008970678 i -7.45 0.9878317879 i -7.5 1.022664977 i -7.55 1.017638075 i -7.6 0.9861398784 i -7.65 1.015262635 i -7.7 1.001623523 i -7.75 1.003549644 i -7.8 0.9805591545 i -7.85 1.007394142 i -7.9 0.9803367825 i -7.95 0.9888274034 i -8 0.9665658006 i -8.05 0.9611406547 i -8.1 0.9696011841 i -8.15 0.9612879559 i -8.2 0.9740415393 i -8.25 0.9570782131 i -8.3 0.970292395 i -8.35 0.9968930245 i -8.4 1.002925264 i -8.45 0.9971135902 i -8.5 0.9944668799 i -8.55 0.9901215978 i -8.6 0.9963226014 i -8.65 1.002471928 i -8.7 0.9972859678 i -8.75 1.000461709 i -8.8 1.007456373 i -8.85 0.9975337886 i -8.9 1.006881375 i -8.95 1.003898668 i -9 1.01939082 i -9.05 1.027863733 i -9.1 1.0126874 i -9.15 1.002986797 i -9.2 1.014592881 i -9.25 0.996218997 i -9.3 1.01434386 i -9.35 1.009318782 i -9.4 1.002409715 i -9.45 1.00752861 i -9.5 1.003738731 i -9.55 1.00546252 i -9.6 1.004475552 i -9.65 1.01401835 i -9.7 0.9999605344 i -9.75 0.9928909486 i -9.8 0.9909424428 i -9.85 0.9900750302 i -9.9 0.9919391121 i -9.95 0.9982970715 i -10 0.9898116624 i -10.05 0.9900764439 i -10.1 0.9969278915 i -10.15 0.9995371762 i -10.2 0.9830245195 i -10.25 0.9985185237 i -10.3 1.011778325 i -10.35 0.987729726 i -10.4 0.9792899029 i -10.45 1.005757012 i -10.5 1.011427913 i -10.55 1.01826943 i -10.6 1.018069644 i -10.65 1.009052089 i -10.7 1.012454415 i -10.75 1.014373714 i -10.8 1.003033618 i -10.85 1.00581897 i -10.9 0.9943814535 i -10.95 0.9987325036 i -11 0.9983875703 i -11.05 1.00760791 i -11.1 1.002375405 i -11.15 1.019653897 i -11.2 1.012683264 i -11.25 1.011799775 i -11.3 0.9985755313 i -11.35 1.004657344 i -11.4 1.011546083 i -11.45 1.006280333 i -11.5 0.9938523349 i -11.55 0.9903439726 i -11.6 0.9903610229 i -11.65 0.9993250672 i -11.7 1.000612865 i -11.75 0.985843493 i -11.8 0.9935396204 i -11.85 0.9961212519 i -11.9 0.9881008469 i -11.95 0.9912340172 i -12 0.9932581399 i -12.05 1.005031664 i -12.1 1.000283189 i -12.15 0.9957382812 i -12.2 0.9905217757 i -12.25 1.005650661 i -12.3 0.9983867528 i -12.35 1.008547414 i -12.4 1.004989106 i -12.45 1.011715734 i -12.5 1.003525112 i -12.55 0.9923659728 i -12.6 0.9925939594 i -12.65 0.993670768 i -12.7 1.006897619 i -12.75 0.9910443316 i -12.8 1.003773488 i -12.85 1.003254426 i -12.9 1.003173391 i -12.95 1.003485179 i -13 0.9982555554 i -13.05 0.9907591011 i -13.1 0.9928898602 i -13.15 0.9995581937 i -13.2 1.004068838 i -13.25 1.001772811 i -13.3 1.002046922 i -13.35 1.000603255 i -13.4 1.011323585 i -13.45 1.009060732 i -13.5 1.013946339 i -13.55 1.005578858 i -13.6 0.9982940357 i -13.65 1.003923923 i -13.7 1.010292528 i -13.75 1.004609556 i -13.8 0.9928580994 i -13.85 1.003973204 i -13.9 0.99837917 i -13.95 0.9980455921 i -14 0.9986529903 i -14.05 0.9917965086 i -14.1 1.00095185 i -14.15 0.9970089013 i -14.2 0.997098635 i -14.25 0.9980037804 i -14.3 1.013908132 i -14.35 1.001934888 i -14.4 1.006664102 i -14.45 0.991726169 i -14.5 0.9912580833 i -14.55 1.008190614 i -14.6 0.9970967502 i -14.65 0.9958736094 i -14.7 0.9903643889 i -14.75 0.9965217067 i -14.8 0.998001776 i -14.85 1.000587917 i -14.9 0.9950512374 i -14.95 0.9958385369 i -15 1.001436413 i diff --git a/examples/PACKAGES/pair_threebody_table/calculate_distributions.xml b/examples/PACKAGES/pair_threebody_table/calculate_distributions.xml deleted file mode 100644 index f2510d4f21..0000000000 --- a/examples/PACKAGES/pair_threebody_table/calculate_distributions.xml +++ /dev/null @@ -1,29 +0,0 @@ - - - grid - - - - - CG-CG - 1 - 1 - 0.0 - 15.0 - 0.05 - - - - - - CG-CG-CG - 1 - 1 - 1 - 1 - 0.0 - 3.1 - 0.05 - 3.7 - - diff --git a/examples/PACKAGES/pair_threebody_table/run.sh b/examples/PACKAGES/pair_threebody_table/run.sh deleted file mode 100755 index c87c01e23e..0000000000 --- a/examples/PACKAGES/pair_threebody_table/run.sh +++ /dev/null @@ -1,8 +0,0 @@ -#! /bin/bash -e - -#run the LAMMPS simulation of the first part of the tutorial (needs a current LAMMPS version compiled with the user pair_style 3b/table) -lmp < spce.in > spce.out - -#run the LAMMPS simulation of the second part of the tutorial (needs a current LAMMPS version compiled with the user pair_style 3b/table) -lmp < spce_2.in > spce_2.out - diff --git a/examples/PACKAGES/pair_threebody_table/spce.in b/examples/PACKAGES/pair_threebody_table/spce.in deleted file mode 100644 index 2ca97708c6..0000000000 --- a/examples/PACKAGES/pair_threebody_table/spce.in +++ /dev/null @@ -1,43 +0,0 @@ -log none - -units real -atom_style atomic - -read_data spce.data - -#hybrid pair style consisting of -#pair_style table to read in CG pair potential -#pair_style threebody/table for tabulated threebody interactions -pair_style hybrid/overlay table linear 1200 threebody/table - -#pair coefficients -pair_coeff 1 1 table table_CG_CG.txt VOTCA -pair_coeff * * threebody/table spce.3b type - -#nvt run with nose-hoover thermostat -#time coupling of 100 ts for thermostat -#target T is 300 K -fix 1 all nvt temp 300.0 300.0 200.0 - -#create initial velocities -velocity all create 300 432567 dist uniform -#remove center of mass linear momentum -velocity all zero linear - -#remove center of mass linear momentum every 1000 time steps in each cartesian direction -fix remove all momentum 1000 linear 1 1 1 - -#timestep of 2 fs -timestep 2.0 - -#print out thermodynamic info every 100 ts -thermo 100 - -#run 10000 ts -run 10000 - -#write out dump file every 10 ts for 100000 ts -dump 2 all custom 10 spce.dump id type x y z fx fy fz -run 100000 - -undump 2 diff --git a/examples/PACKAGES/pair_threebody_table/spce_2.in b/examples/PACKAGES/pair_threebody_table/spce_2.in deleted file mode 100644 index e05df5d719..0000000000 --- a/examples/PACKAGES/pair_threebody_table/spce_2.in +++ /dev/null @@ -1,43 +0,0 @@ -log none - -units real -atom_style atomic - -read_data spce_2.data - -#hybrid pair style consisting of -#pair_style table to read in CG pair potential -#pair_style threebody/table for tabulated threebody interactions -pair_style hybrid/overlay table linear 1200 threebody/table - -#pair coefficients -pair_coeff * * table table_CG_CG.txt VOTCA -pair_coeff * * threebody/table spce_2.3b type1 type2 - -#nvt run with nose-hoover thermostat -#time coupling of 100 ts for thermostat -#target T is 300 K -fix 1 all nvt temp 300.0 300.0 200.0 - -#create initial velocities -velocity all create 300 432567 dist uniform -#remove center of mass linear momentum -velocity all zero linear - -#remove center of mass linear momentum every 1000 time steps in each cartesian direction -fix remove all momentum 1000 linear 1 1 1 - -#timestep of 2 fs -timestep 2.0 - -#print out thermodynamic info every 100 ts -thermo 100 - -#run 10000 ts -run 10000 - -#write out dump file every 10 ts for 100000 ts -dump 2 all custom 10 spce_2.dump id type x y z fx fy fz -run 100000 - -undump 2 From edea4fa9a2fbdf660fc5df54133938c5a7c10aa9 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 1 Jun 2022 14:23:30 -0400 Subject: [PATCH 273/585] fix memory allocation/communication issues. avoid memory leaks. --- src/MANYBODY/pair_threebody_table.cpp | 68 ++++++++++++--------------- 1 file changed, 31 insertions(+), 37 deletions(-) diff --git a/src/MANYBODY/pair_threebody_table.cpp b/src/MANYBODY/pair_threebody_table.cpp index 201e2a77a2..1ce68dbf69 100644 --- a/src/MANYBODY/pair_threebody_table.cpp +++ b/src/MANYBODY/pair_threebody_table.cpp @@ -31,8 +31,6 @@ #include #include -// -#include using namespace LAMMPS_NS; using MathConst::MY_PI; @@ -205,12 +203,12 @@ void PairThreebodyTable::compute(int eflag, int vflag) void PairThreebodyTable::allocate() { allocated = 1; - int n = atom->ntypes; + int np1 = atom->ntypes + 1; - memory->create(setflag,n+1,n+1,"pair:setflag"); - memory->create(cutsq,n+1,n+1,"pair:cutsq"); + memory->create(setflag,np1,np1,"pair:setflag"); + memory->create(cutsq,np1,np1,"pair:cutsq"); memory->create(neighshort,maxshort,"pair:neighshort"); - map = new int[n+1]; + map = new int[np1]; } /* ---------------------------------------------------------------------- @@ -234,6 +232,11 @@ void PairThreebodyTable::coeff(int narg, char **arg) // read potential file and initialize potential parameters + if (params) { + for (int m = 0; m < nparams; m++) free_param(¶ms[m]); // free_param will call free_table + memory->sfree(params); + params = nullptr; + } read_file(arg[2]); setup_params(); } @@ -269,7 +272,6 @@ double PairThreebodyTable::init_one(int i, int j) void PairThreebodyTable::read_file(char *file) { - memory->sfree(params); params = nullptr; nparams = maxparam = 0; @@ -325,21 +327,17 @@ void PairThreebodyTable::read_file(char *file) params[nparams].cut = values.next_double(); // read parameters of angle table - std::string tablename_string = values.next_string(); - params[nparams].tablenamelength = tablename_string.length()+1; - memory->create(params[nparams].tablename, params[nparams].tablenamelength, "params.tablename"); - for (int x = 0; x < params[nparams].tablenamelength; ++x) { - params[nparams].tablename[x] = tablename_string[x]; - } - std::string keyword_string = values.next_string(); - params[nparams].keywordlength = keyword_string.length()+1; - memory->create(params[nparams].keyword, params[nparams].keywordlength, "params.keyword"); - for (int x = 0; x < params[nparams].keywordlength; ++x) { - params[nparams].keyword[x] = keyword_string[x]; - } - auto tablestyle = values.next_string(); - if (tablestyle != "linear") - error->all(FLERR,"Unknown table style {} in threebody table", tablestyle); + std::string name = values.next_string(); + params[nparams].tablenamelength = name.length()+1; + params[nparams].tablename = utils::strdup(name); + + name = values.next_string(); + params[nparams].keywordlength = name.length()+1; + params[nparams].keyword = utils::strdup(name); + + name = values.next_string(); + if (name != "linear") + error->all(FLERR,"Unknown table style {} in threebody table", name); params[nparams].tablength = values.next_int(); } catch (TokenizerException &e) { @@ -356,29 +354,25 @@ void PairThreebodyTable::read_file(char *file) MPI_Bcast(&nparams, 1, MPI_INT, 0, world); MPI_Bcast(&maxparam, 1, MPI_INT, 0, world); - if (comm->me != 0) { - params = (Param *) memory->srealloc(params,maxparam*sizeof(Param), "pair:params"); - } - + if (comm->me != 0) params = (Param *) memory->srealloc(params,maxparam*sizeof(Param), "pair:params"); MPI_Bcast(params, maxparam*sizeof(Param), MPI_BYTE, 0, world); // for each set of parameters, broadcast table name and keyword and read threebody table for (int m = 0; m < nparams; ++m){ if (comm->me != 0) { - memory->create(params[m].tablename, params[m].tablenamelength, "params.tablename"); + params[m].tablename = new char[params[m].tablenamelength]; + params[m].keyword = new char[params[m].keywordlength]; } - MPI_Bcast(¶ms[m].tablename, params[m].tablenamelength, MPI_CHAR, 0, world); - if (comm->me != 0) { - memory->create(params[m].keyword, params[m].keywordlength, "params.keyword"); - } - MPI_Bcast(¶ms[m].keyword, params[m].keywordlength, MPI_CHAR, 0, world); + + MPI_Bcast(params[m].tablename, params[m].tablenamelength, MPI_CHAR, 0, world); + MPI_Bcast(params[m].keyword, params[m].keywordlength, MPI_CHAR, 0, world); // initialize threebodytable memory->create(params[m].mltable,1,"param:threebodytable"); null_table(params[m].mltable); //call read_table to read corresponding tabulated threebody file (only called by process 0) - if (comm->me == 0){ + if (comm->me == 0) { read_table(params[m].mltable,params[m].tablename,params[m].keyword,params[m].symmetric); } @@ -570,7 +564,7 @@ void PairThreebodyTable::param_extract(Table *tb, char *line) } else if (word == "rmax") { tb->rmax = values.next_double(); } else { - error->one(FLERR, "Invalid keyword in angle table parameters"); + error->one(FLERR, "Invalid keyword {} in angle table parameters", word); } } } catch (TokenizerException &e) { @@ -659,11 +653,11 @@ void PairThreebodyTable::bcast_table(Table *tb, bool symmetric) void PairThreebodyTable::free_param(Param *pm) { - // call free_table to destroy associated threebodytable + // call free_table to destroy associated threebodytables free_table(pm->mltable); // then destroy associated threebodytable - memory->sfree(pm->tablename); - memory->sfree(pm->keyword); + delete[] pm->tablename; + delete[] pm->keyword; memory->sfree(pm->mltable); } From b9b0d7207c495add938df885d5b22028939612cb Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 1 Jun 2022 14:24:23 -0400 Subject: [PATCH 274/585] apply clang-format --- src/MANYBODY/pair_threebody_table.cpp | 385 ++++++++++++-------------- 1 file changed, 183 insertions(+), 202 deletions(-) diff --git a/src/MANYBODY/pair_threebody_table.cpp b/src/MANYBODY/pair_threebody_table.cpp index 1ce68dbf69..14f3c261d9 100644 --- a/src/MANYBODY/pair_threebody_table.cpp +++ b/src/MANYBODY/pair_threebody_table.cpp @@ -26,8 +26,8 @@ #include "memory.h" #include "neigh_list.h" #include "neighbor.h" -#include "table_file_reader.h" #include "potential_file_reader.h" +#include "table_file_reader.h" #include #include @@ -39,7 +39,8 @@ using MathConst::MY_PI; /* ---------------------------------------------------------------------- */ -PairThreebodyTable::PairThreebodyTable(LAMMPS *lmp) : Pair(lmp), params(nullptr), neighshort(nullptr) +PairThreebodyTable::PairThreebodyTable(LAMMPS *lmp) : + Pair(lmp), params(nullptr), neighshort(nullptr) { single_enable = 0; restartinfo = 0; @@ -58,7 +59,7 @@ PairThreebodyTable::~PairThreebodyTable() { if (copymode) return; - for (int m = 0; m < nparams; m++) free_param(¶ms[m]); // free_param will call free_table + for (int m = 0; m < nparams; m++) free_param(¶ms[m]); // free_param will call free_table memory->sfree(params); memory->destroy(elem3param); @@ -73,16 +74,16 @@ PairThreebodyTable::~PairThreebodyTable() void PairThreebodyTable::compute(int eflag, int vflag) { - int i,j,k,ii,jj,kk,inum,jnum,jnumm1; - int itype,jtype,ktype,ijparam,ijkparam; - tagint itag,jtag; - double xtmp,ytmp,ztmp,delx,dely,delz,evdwl; - double rsq,rsq1,rsq2; - double delr1[3],delr2[3],fi[3],fj[3],fk[3]; - int *ilist,*jlist,*numneigh,**firstneigh; + int i, j, k, ii, jj, kk, inum, jnum, jnumm1; + int itype, jtype, ktype, ijparam, ijkparam; + tagint itag, jtag; + double xtmp, ytmp, ztmp, delx, dely, delz, evdwl; + double rsq, rsq1, rsq2; + double delr1[3], delr2[3], fi[3], fj[3], fk[3]; + int *ilist, *jlist, *numneigh, **firstneigh; evdwl = 0.0; - ev_init(eflag,vflag); + ev_init(eflag, vflag); double **x = atom->x; double **f = atom->f; @@ -94,7 +95,7 @@ void PairThreebodyTable::compute(int eflag, int vflag) numneigh = list->numneigh; firstneigh = list->firstneigh; - double fxtmp,fytmp,fztmp; + double fxtmp, fytmp, fztmp; // loop over full neighbor list of my atoms @@ -120,7 +121,7 @@ void PairThreebodyTable::compute(int eflag, int vflag) delx = xtmp - x[j][0]; dely = ytmp - x[j][1]; delz = ztmp - x[j][2]; - rsq = delx*delx + dely*dely + delz*delz; + rsq = delx * delx + dely * dely + delz * delz; jtype = map[type[j]]; ijparam = elem3param[itype][jtype][jtype]; @@ -129,16 +130,16 @@ void PairThreebodyTable::compute(int eflag, int vflag) } else { neighshort[numshort++] = j; if (numshort >= maxshort) { - maxshort += maxshort/2; - memory->grow(neighshort,maxshort,"pair:neighshort"); + maxshort += maxshort / 2; + memory->grow(neighshort, maxshort, "pair:neighshort"); } } jtag = tag[j]; if (itag > jtag) { - if ((itag+jtag) % 2 == 0) continue; + if ((itag + jtag) % 2 == 0) continue; } else if (itag < jtag) { - if ((itag+jtag) % 2 == 1) continue; + if ((itag + jtag) % 2 == 1) continue; } else { if (x[j][2] < ztmp) continue; if (x[j][2] == ztmp && x[j][1] < ytmp) continue; @@ -157,12 +158,12 @@ void PairThreebodyTable::compute(int eflag, int vflag) delr1[0] = x[j][0] - xtmp; delr1[1] = x[j][1] - ytmp; delr1[2] = x[j][2] - ztmp; - rsq1 = delr1[0]*delr1[0] + delr1[1]*delr1[1] + delr1[2]*delr1[2]; + rsq1 = delr1[0] * delr1[0] + delr1[1] * delr1[1] + delr1[2] * delr1[2]; - double fjxtmp,fjytmp,fjztmp; + double fjxtmp, fjytmp, fjztmp; fjxtmp = fjytmp = fjztmp = 0.0; - for (kk = jj+1; kk < numshort; kk++) { + for (kk = jj + 1; kk < numshort; kk++) { k = neighshort[kk]; ktype = map[type[k]]; ijkparam = elem3param[itype][jtype][ktype]; @@ -170,9 +171,9 @@ void PairThreebodyTable::compute(int eflag, int vflag) delr2[0] = x[k][0] - xtmp; delr2[1] = x[k][1] - ytmp; delr2[2] = x[k][2] - ztmp; - rsq2 = delr2[0]*delr2[0] + delr2[1]*delr2[1] + delr2[2]*delr2[2]; + rsq2 = delr2[0] * delr2[0] + delr2[1] * delr2[1] + delr2[2] * delr2[2]; - threebody(¶ms[ijkparam],rsq1,rsq2,delr1,delr2,fi,fj,fk,eflag,evdwl); + threebody(¶ms[ijkparam], rsq1, rsq2, delr1, delr2, fi, fj, fk, eflag, evdwl); fxtmp += fi[0]; fytmp += fi[1]; @@ -184,7 +185,7 @@ void PairThreebodyTable::compute(int eflag, int vflag) f[k][1] += fk[1]; f[k][2] += fk[2]; - if (evflag) ev_tally3(i,j,k,evdwl,0.0,fj,fk,delr1,delr2); + if (evflag) ev_tally3(i, j, k, evdwl, 0.0, fj, fk, delr1, delr2); } f[j][0] += fjxtmp; f[j][1] += fjytmp; @@ -205,9 +206,9 @@ void PairThreebodyTable::allocate() allocated = 1; int np1 = atom->ntypes + 1; - memory->create(setflag,np1,np1,"pair:setflag"); - memory->create(cutsq,np1,np1,"pair:cutsq"); - memory->create(neighshort,maxshort,"pair:neighshort"); + memory->create(setflag, np1, np1, "pair:setflag"); + memory->create(cutsq, np1, np1, "pair:cutsq"); + memory->create(neighshort, maxshort, "pair:neighshort"); map = new int[np1]; } @@ -217,7 +218,7 @@ void PairThreebodyTable::allocate() void PairThreebodyTable::settings(int narg, char ** /*arg*/) { - if (narg != 0) error->all(FLERR,"Illegal pair_style command"); + if (narg != 0) error->all(FLERR, "Illegal pair_style command"); } /* ---------------------------------------------------------------------- @@ -228,12 +229,12 @@ void PairThreebodyTable::coeff(int narg, char **arg) { if (!allocated) allocate(); - map_element2type(narg-3,arg+3); + map_element2type(narg - 3, arg + 3); // read potential file and initialize potential parameters if (params) { - for (int m = 0; m < nparams; m++) free_param(¶ms[m]); // free_param will call free_table + for (int m = 0; m < nparams; m++) free_param(¶ms[m]); // free_param will call free_table memory->sfree(params); params = nullptr; } @@ -247,10 +248,9 @@ void PairThreebodyTable::coeff(int narg, char **arg) void PairThreebodyTable::init_style() { - if (atom->tag_enable == 0) - error->all(FLERR,"Pair style threebody/table requires atom IDs"); + if (atom->tag_enable == 0) error->all(FLERR, "Pair style threebody/table requires atom IDs"); if (force->newton_pair == 0) - error->all(FLERR,"Pair style threebody/table requires newton pair on"); + error->all(FLERR, "Pair style threebody/table requires newton pair on"); // need a full neighbor list @@ -263,7 +263,7 @@ void PairThreebodyTable::init_style() double PairThreebodyTable::init_one(int i, int j) { - if (setflag[i][j] == 0) error->all(FLERR,"All pair coeffs are not set"); + if (setflag[i][j] == 0) error->all(FLERR, "All pair coeffs are not set"); return cutmax; } @@ -308,13 +308,12 @@ void PairThreebodyTable::read_file(char *file) if (nparams == maxparam) { maxparam += DELTA; - params = (Param *) memory->srealloc(params,maxparam*sizeof(Param), - "pair:params"); + params = (Param *) memory->srealloc(params, maxparam * sizeof(Param), "pair:params"); // make certain all addional allocated storage is initialized // to avoid false positives when checking with valgrind - memset(params + nparams, 0, DELTA*sizeof(Param)); + memset(params + nparams, 0, DELTA * sizeof(Param)); } params[nparams].ielement = ielement; @@ -328,16 +327,15 @@ void PairThreebodyTable::read_file(char *file) // read parameters of angle table std::string name = values.next_string(); - params[nparams].tablenamelength = name.length()+1; + params[nparams].tablenamelength = name.length() + 1; params[nparams].tablename = utils::strdup(name); name = values.next_string(); - params[nparams].keywordlength = name.length()+1; + params[nparams].keywordlength = name.length() + 1; params[nparams].keyword = utils::strdup(name); name = values.next_string(); - if (name != "linear") - error->all(FLERR,"Unknown table style {} in threebody table", name); + if (name != "linear") error->all(FLERR, "Unknown table style {} in threebody table", name); params[nparams].tablength = values.next_int(); } catch (TokenizerException &e) { @@ -345,7 +343,7 @@ void PairThreebodyTable::read_file(char *file) } if (params[nparams].cut < 0.0 || params[nparams].tablength < 0.0) - error->one(FLERR,"Illegal threebody/table parameters"); + error->one(FLERR, "Illegal threebody/table parameters"); nparams++; } @@ -354,42 +352,42 @@ void PairThreebodyTable::read_file(char *file) MPI_Bcast(&nparams, 1, MPI_INT, 0, world); MPI_Bcast(&maxparam, 1, MPI_INT, 0, world); - if (comm->me != 0) params = (Param *) memory->srealloc(params,maxparam*sizeof(Param), "pair:params"); - MPI_Bcast(params, maxparam*sizeof(Param), MPI_BYTE, 0, world); + if (comm->me != 0) + params = (Param *) memory->srealloc(params, maxparam * sizeof(Param), "pair:params"); + MPI_Bcast(params, maxparam * sizeof(Param), MPI_BYTE, 0, world); // for each set of parameters, broadcast table name and keyword and read threebody table - for (int m = 0; m < nparams; ++m){ + for (int m = 0; m < nparams; ++m) { if (comm->me != 0) { params[m].tablename = new char[params[m].tablenamelength]; params[m].keyword = new char[params[m].keywordlength]; } - + MPI_Bcast(params[m].tablename, params[m].tablenamelength, MPI_CHAR, 0, world); MPI_Bcast(params[m].keyword, params[m].keywordlength, MPI_CHAR, 0, world); // initialize threebodytable - memory->create(params[m].mltable,1,"param:threebodytable"); + memory->create(params[m].mltable, 1, "param:threebodytable"); null_table(params[m].mltable); //call read_table to read corresponding tabulated threebody file (only called by process 0) if (comm->me == 0) { - read_table(params[m].mltable,params[m].tablename,params[m].keyword,params[m].symmetric); + read_table(params[m].mltable, params[m].tablename, params[m].keyword, params[m].symmetric); } // broadcast read in threebodytable to all processes - bcast_table(params[m].mltable,params[m].symmetric); + bcast_table(params[m].mltable, params[m].symmetric); // error check on table parameters - if (params[m].mltable->ninput <= 1) error->one(FLERR,"Invalid threebody table length"); + if (params[m].mltable->ninput <= 1) error->one(FLERR, "Invalid threebody table length"); } } - /* ---------------------------------------------------------------------- */ void PairThreebodyTable::setup_params() { - int i,j,k,m,n; + int i, j, k, m, n; double rtmp; // set elem3param for all triplet combinations @@ -397,24 +395,22 @@ void PairThreebodyTable::setup_params() // do not allow for ACB in place of ABC memory->destroy(elem3param); - memory->create(elem3param,nelements,nelements,nelements,"pair:elem3param"); + memory->create(elem3param, nelements, nelements, nelements, "pair:elem3param"); for (i = 0; i < nelements; i++) for (j = 0; j < nelements; j++) for (k = 0; k < nelements; k++) { n = -1; for (m = 0; m < nparams; m++) { - if (i == params[m].ielement && j == params[m].jelement && - k == params[m].kelement) { - if (n >= 0) error->all(FLERR,"Potential file has duplicate entry"); + if (i == params[m].ielement && j == params[m].jelement && k == params[m].kelement) { + if (n >= 0) error->all(FLERR, "Potential file has duplicate entry"); n = m; } } - if (n < 0) error->all(FLERR,"Potential file is missing an entry"); + if (n < 0) error->all(FLERR, "Potential file is missing an entry"); elem3param[i][j][k] = n; } - // compute parameter values derived from inputs // set cutsq using shortcut to reduce neighbor list for accelerated @@ -426,7 +422,6 @@ void PairThreebodyTable::setup_params() params[m].cutsq = rtmp * rtmp; } - // set cutmax to max of all params cutmax = 0.0; @@ -455,40 +450,39 @@ void PairThreebodyTable::read_table(Table *tb, char *file, char *keyword, bool s param_extract(tb, line); // if it is a symmetric threebody interaction, less table entries are required - if (symmetric == true){ - memory->create(tb->r12file,tb->ninput*tb->ninput*(tb->ninput+1),"mltable:r12file"); - memory->create(tb->r13file,tb->ninput*tb->ninput*(tb->ninput+1),"mltable:r13file"); - memory->create(tb->thetafile,tb->ninput*tb->ninput*(tb->ninput+1),"mltable:thetafile"); - memory->create(tb->f11file,tb->ninput*tb->ninput*(tb->ninput+1),"mltable:f11file"); - memory->create(tb->f12file,tb->ninput*tb->ninput*(tb->ninput+1),"mltable:f12file"); - memory->create(tb->f21file,tb->ninput*tb->ninput*(tb->ninput+1),"mltable:f21file"); - memory->create(tb->f22file,tb->ninput*tb->ninput*(tb->ninput+1),"mltable:f22file"); - memory->create(tb->f31file,tb->ninput*tb->ninput*(tb->ninput+1),"mltable:f31file"); - memory->create(tb->f32file,tb->ninput*tb->ninput*(tb->ninput+1),"mltable:f32file"); - memory->create(tb->efile,tb->ninput*tb->ninput*(tb->ninput+1),"mltable:efile"); + if (symmetric == true) { + memory->create(tb->r12file, tb->ninput * tb->ninput * (tb->ninput + 1), "mltable:r12file"); + memory->create(tb->r13file, tb->ninput * tb->ninput * (tb->ninput + 1), "mltable:r13file"); + memory->create(tb->thetafile, tb->ninput * tb->ninput * (tb->ninput + 1), "mltable:thetafile"); + memory->create(tb->f11file, tb->ninput * tb->ninput * (tb->ninput + 1), "mltable:f11file"); + memory->create(tb->f12file, tb->ninput * tb->ninput * (tb->ninput + 1), "mltable:f12file"); + memory->create(tb->f21file, tb->ninput * tb->ninput * (tb->ninput + 1), "mltable:f21file"); + memory->create(tb->f22file, tb->ninput * tb->ninput * (tb->ninput + 1), "mltable:f22file"); + memory->create(tb->f31file, tb->ninput * tb->ninput * (tb->ninput + 1), "mltable:f31file"); + memory->create(tb->f32file, tb->ninput * tb->ninput * (tb->ninput + 1), "mltable:f32file"); + memory->create(tb->efile, tb->ninput * tb->ninput * (tb->ninput + 1), "mltable:efile"); } // else, more (full) table entries are required - else{ - memory->create(tb->r12file,2*tb->ninput*tb->ninput*tb->ninput,"mltable:r12file"); - memory->create(tb->r13file,2*tb->ninput*tb->ninput*tb->ninput,"mltable:r13file"); - memory->create(tb->thetafile,2*tb->ninput*tb->ninput*tb->ninput,"mltable:thetafile"); - memory->create(tb->f11file,2*tb->ninput*tb->ninput*tb->ninput,"mltable:f11file"); - memory->create(tb->f12file,2*tb->ninput*tb->ninput*tb->ninput,"mltable:f12file"); - memory->create(tb->f21file,2*tb->ninput*tb->ninput*tb->ninput,"mltable:f21file"); - memory->create(tb->f22file,2*tb->ninput*tb->ninput*tb->ninput,"mltable:f22file"); - memory->create(tb->f31file,2*tb->ninput*tb->ninput*tb->ninput,"mltable:f31file"); - memory->create(tb->f32file,2*tb->ninput*tb->ninput*tb->ninput,"mltable:f32file"); - memory->create(tb->efile,2*tb->ninput*tb->ninput*tb->ninput,"mltable:efile"); + else { + memory->create(tb->r12file, 2 * tb->ninput * tb->ninput * tb->ninput, "mltable:r12file"); + memory->create(tb->r13file, 2 * tb->ninput * tb->ninput * tb->ninput, "mltable:r13file"); + memory->create(tb->thetafile, 2 * tb->ninput * tb->ninput * tb->ninput, "mltable:thetafile"); + memory->create(tb->f11file, 2 * tb->ninput * tb->ninput * tb->ninput, "mltable:f11file"); + memory->create(tb->f12file, 2 * tb->ninput * tb->ninput * tb->ninput, "mltable:f12file"); + memory->create(tb->f21file, 2 * tb->ninput * tb->ninput * tb->ninput, "mltable:f21file"); + memory->create(tb->f22file, 2 * tb->ninput * tb->ninput * tb->ninput, "mltable:f22file"); + memory->create(tb->f31file, 2 * tb->ninput * tb->ninput * tb->ninput, "mltable:f31file"); + memory->create(tb->f32file, 2 * tb->ninput * tb->ninput * tb->ninput, "mltable:f32file"); + memory->create(tb->efile, 2 * tb->ninput * tb->ninput * tb->ninput, "mltable:efile"); } - // read threebody table values from file int cerror = 0; reader.skip_line(); // if it is a symmetric threebody interaction, less table entries are required - if (symmetric == true){ - for (int i = 0; i < tb->ninput*tb->ninput*(tb->ninput+1); i++) { + if (symmetric == true) { + for (int i = 0; i < tb->ninput * tb->ninput * (tb->ninput + 1); i++) { line = reader.next_line(11); try { ValueTokenizer values(line); @@ -507,9 +501,8 @@ void PairThreebodyTable::read_table(Table *tb, char *file, char *keyword, bool s ++cerror; } } - } - else{ - for (int i = 0; i < 2*tb->ninput*tb->ninput*tb->ninput; i++) { + } else { + for (int i = 0; i < 2 * tb->ninput * tb->ninput * tb->ninput; i++) { line = reader.next_line(11); try { ValueTokenizer values(line); @@ -576,7 +569,6 @@ void PairThreebodyTable::param_extract(Table *tb, char *line) if (tb->rmax == 0.0) error->one(FLERR, "threebodytable parameters did not set rmax"); } - /* ---------------------------------------------------------------------- broadcast read-in table info from proc 0 to other procs this function communicates these values in Table: @@ -585,68 +577,69 @@ void PairThreebodyTable::param_extract(Table *tb, char *line) void PairThreebodyTable::bcast_table(Table *tb, bool symmetric) { - MPI_Bcast(&tb->ninput,1,MPI_INT,0,world); + MPI_Bcast(&tb->ninput, 1, MPI_INT, 0, world); int me; MPI_Comm_rank(world, &me); if (me > 0) { // if it is a symmetric threebody interaction, less table entries are required - if (symmetric == true){ - memory->create(tb->r12file,tb->ninput*tb->ninput*(tb->ninput+1),"mltable:r12file"); - memory->create(tb->r13file,tb->ninput*tb->ninput*(tb->ninput+1),"mltable:r13file"); - memory->create(tb->thetafile,tb->ninput*tb->ninput*(tb->ninput+1),"mltable:thetafile"); - memory->create(tb->f11file,tb->ninput*tb->ninput*(tb->ninput+1),"mltable:f11file"); - memory->create(tb->f12file,tb->ninput*tb->ninput*(tb->ninput+1),"mltable:f12file"); - memory->create(tb->f21file,tb->ninput*tb->ninput*(tb->ninput+1),"mltable:f21file"); - memory->create(tb->f22file,tb->ninput*tb->ninput*(tb->ninput+1),"mltable:f22file"); - memory->create(tb->f31file,tb->ninput*tb->ninput*(tb->ninput+1),"mltable:f31file"); - memory->create(tb->f32file,tb->ninput*tb->ninput*(tb->ninput+1),"mltable:f32file"); - memory->create(tb->efile,tb->ninput*tb->ninput*(tb->ninput+1),"mltable:efile"); + if (symmetric == true) { + memory->create(tb->r12file, tb->ninput * tb->ninput * (tb->ninput + 1), "mltable:r12file"); + memory->create(tb->r13file, tb->ninput * tb->ninput * (tb->ninput + 1), "mltable:r13file"); + memory->create(tb->thetafile, tb->ninput * tb->ninput * (tb->ninput + 1), + "mltable:thetafile"); + memory->create(tb->f11file, tb->ninput * tb->ninput * (tb->ninput + 1), "mltable:f11file"); + memory->create(tb->f12file, tb->ninput * tb->ninput * (tb->ninput + 1), "mltable:f12file"); + memory->create(tb->f21file, tb->ninput * tb->ninput * (tb->ninput + 1), "mltable:f21file"); + memory->create(tb->f22file, tb->ninput * tb->ninput * (tb->ninput + 1), "mltable:f22file"); + memory->create(tb->f31file, tb->ninput * tb->ninput * (tb->ninput + 1), "mltable:f31file"); + memory->create(tb->f32file, tb->ninput * tb->ninput * (tb->ninput + 1), "mltable:f32file"); + memory->create(tb->efile, tb->ninput * tb->ninput * (tb->ninput + 1), "mltable:efile"); } // else, more (full) table entries are required - else{ - memory->create(tb->r12file,2*tb->ninput*tb->ninput*tb->ninput,"mltable:r12file"); - memory->create(tb->r13file,2*tb->ninput*tb->ninput*tb->ninput,"mltable:r13file"); - memory->create(tb->thetafile,2*tb->ninput*tb->ninput*tb->ninput,"mltable:thetafile"); - memory->create(tb->f11file,2*tb->ninput*tb->ninput*tb->ninput,"mltable:f11file"); - memory->create(tb->f12file,2*tb->ninput*tb->ninput*tb->ninput,"mltable:f12file"); - memory->create(tb->f21file,2*tb->ninput*tb->ninput*tb->ninput,"mltable:f21file"); - memory->create(tb->f22file,2*tb->ninput*tb->ninput*tb->ninput,"mltable:f22file"); - memory->create(tb->f31file,2*tb->ninput*tb->ninput*tb->ninput,"mltable:f31file"); - memory->create(tb->f32file,2*tb->ninput*tb->ninput*tb->ninput,"mltable:f32file"); - memory->create(tb->efile,2*tb->ninput*tb->ninput*tb->ninput,"mltable:efile"); + else { + memory->create(tb->r12file, 2 * tb->ninput * tb->ninput * tb->ninput, "mltable:r12file"); + memory->create(tb->r13file, 2 * tb->ninput * tb->ninput * tb->ninput, "mltable:r13file"); + memory->create(tb->thetafile, 2 * tb->ninput * tb->ninput * tb->ninput, "mltable:thetafile"); + memory->create(tb->f11file, 2 * tb->ninput * tb->ninput * tb->ninput, "mltable:f11file"); + memory->create(tb->f12file, 2 * tb->ninput * tb->ninput * tb->ninput, "mltable:f12file"); + memory->create(tb->f21file, 2 * tb->ninput * tb->ninput * tb->ninput, "mltable:f21file"); + memory->create(tb->f22file, 2 * tb->ninput * tb->ninput * tb->ninput, "mltable:f22file"); + memory->create(tb->f31file, 2 * tb->ninput * tb->ninput * tb->ninput, "mltable:f31file"); + memory->create(tb->f32file, 2 * tb->ninput * tb->ninput * tb->ninput, "mltable:f32file"); + memory->create(tb->efile, 2 * tb->ninput * tb->ninput * tb->ninput, "mltable:efile"); } } // if it is a symmetric threebody interaction, less table entries are required - if (symmetric == true){ - MPI_Bcast(tb->r12file,tb->ninput*tb->ninput*(tb->ninput+1),MPI_DOUBLE,0,world); - MPI_Bcast(tb->r13file,tb->ninput*tb->ninput*(tb->ninput+1),MPI_DOUBLE,0,world); - MPI_Bcast(tb->thetafile,tb->ninput*tb->ninput*(tb->ninput+1),MPI_DOUBLE,0,world); - MPI_Bcast(tb->f11file,tb->ninput*tb->ninput*(tb->ninput+1),MPI_DOUBLE,0,world); - MPI_Bcast(tb->f12file,tb->ninput*tb->ninput*(tb->ninput+1),MPI_DOUBLE,0,world); - MPI_Bcast(tb->f21file,tb->ninput*tb->ninput*(tb->ninput+1),MPI_DOUBLE,0,world); - MPI_Bcast(tb->f22file,tb->ninput*tb->ninput*(tb->ninput+1),MPI_DOUBLE,0,world); - MPI_Bcast(tb->f31file,tb->ninput*tb->ninput*(tb->ninput+1),MPI_DOUBLE,0,world); - MPI_Bcast(tb->f32file,tb->ninput*tb->ninput*(tb->ninput+1),MPI_DOUBLE,0,world); - MPI_Bcast(tb->efile,tb->ninput*tb->ninput*(tb->ninput+1),MPI_DOUBLE,0,world); + if (symmetric == true) { + MPI_Bcast(tb->r12file, tb->ninput * tb->ninput * (tb->ninput + 1), MPI_DOUBLE, 0, world); + MPI_Bcast(tb->r13file, tb->ninput * tb->ninput * (tb->ninput + 1), MPI_DOUBLE, 0, world); + MPI_Bcast(tb->thetafile, tb->ninput * tb->ninput * (tb->ninput + 1), MPI_DOUBLE, 0, world); + MPI_Bcast(tb->f11file, tb->ninput * tb->ninput * (tb->ninput + 1), MPI_DOUBLE, 0, world); + MPI_Bcast(tb->f12file, tb->ninput * tb->ninput * (tb->ninput + 1), MPI_DOUBLE, 0, world); + MPI_Bcast(tb->f21file, tb->ninput * tb->ninput * (tb->ninput + 1), MPI_DOUBLE, 0, world); + MPI_Bcast(tb->f22file, tb->ninput * tb->ninput * (tb->ninput + 1), MPI_DOUBLE, 0, world); + MPI_Bcast(tb->f31file, tb->ninput * tb->ninput * (tb->ninput + 1), MPI_DOUBLE, 0, world); + MPI_Bcast(tb->f32file, tb->ninput * tb->ninput * (tb->ninput + 1), MPI_DOUBLE, 0, world); + MPI_Bcast(tb->efile, tb->ninput * tb->ninput * (tb->ninput + 1), MPI_DOUBLE, 0, world); } // else, more (full) table entries are required - else{ - MPI_Bcast(tb->r12file,2*tb->ninput*tb->ninput*tb->ninput,MPI_DOUBLE,0,world); - MPI_Bcast(tb->r13file,2*tb->ninput*tb->ninput*tb->ninput,MPI_DOUBLE,0,world); - MPI_Bcast(tb->thetafile,2*tb->ninput*tb->ninput*tb->ninput,MPI_DOUBLE,0,world); - MPI_Bcast(tb->f11file,2*tb->ninput*tb->ninput*tb->ninput,MPI_DOUBLE,0,world); - MPI_Bcast(tb->f12file,2*tb->ninput*tb->ninput*tb->ninput,MPI_DOUBLE,0,world); - MPI_Bcast(tb->f21file,2*tb->ninput*tb->ninput*tb->ninput,MPI_DOUBLE,0,world); - MPI_Bcast(tb->f22file,2*tb->ninput*tb->ninput*tb->ninput,MPI_DOUBLE,0,world); - MPI_Bcast(tb->f31file,2*tb->ninput*tb->ninput*tb->ninput,MPI_DOUBLE,0,world); - MPI_Bcast(tb->f32file,2*tb->ninput*tb->ninput*tb->ninput,MPI_DOUBLE,0,world); - MPI_Bcast(tb->efile,2*tb->ninput*tb->ninput*tb->ninput,MPI_DOUBLE,0,world); + else { + MPI_Bcast(tb->r12file, 2 * tb->ninput * tb->ninput * tb->ninput, MPI_DOUBLE, 0, world); + MPI_Bcast(tb->r13file, 2 * tb->ninput * tb->ninput * tb->ninput, MPI_DOUBLE, 0, world); + MPI_Bcast(tb->thetafile, 2 * tb->ninput * tb->ninput * tb->ninput, MPI_DOUBLE, 0, world); + MPI_Bcast(tb->f11file, 2 * tb->ninput * tb->ninput * tb->ninput, MPI_DOUBLE, 0, world); + MPI_Bcast(tb->f12file, 2 * tb->ninput * tb->ninput * tb->ninput, MPI_DOUBLE, 0, world); + MPI_Bcast(tb->f21file, 2 * tb->ninput * tb->ninput * tb->ninput, MPI_DOUBLE, 0, world); + MPI_Bcast(tb->f22file, 2 * tb->ninput * tb->ninput * tb->ninput, MPI_DOUBLE, 0, world); + MPI_Bcast(tb->f31file, 2 * tb->ninput * tb->ninput * tb->ninput, MPI_DOUBLE, 0, world); + MPI_Bcast(tb->f32file, 2 * tb->ninput * tb->ninput * tb->ninput, MPI_DOUBLE, 0, world); + MPI_Bcast(tb->efile, 2 * tb->ninput * tb->ninput * tb->ninput, MPI_DOUBLE, 0, world); } - MPI_Bcast(&tb->rmin,1,MPI_DOUBLE,0,world); - MPI_Bcast(&tb->rmax,1,MPI_DOUBLE,0,world); + MPI_Bcast(&tb->rmin, 1, MPI_DOUBLE, 0, world); + MPI_Bcast(&tb->rmax, 1, MPI_DOUBLE, 0, world); } /* ---------------------------------------------------------------------- */ @@ -692,91 +685,79 @@ void PairThreebodyTable::null_table(Table *tb) calculate potential u and force f at angle x ------------------------------------------------------------------------- */ -void PairThreebodyTable::uf_lookup(Param *pm, double r12, double r13, double theta, double &f11, double &f12, - double &f21, double &f22, double &f31, double &f32, double &u) +void PairThreebodyTable::uf_lookup(Param *pm, double r12, double r13, double theta, double &f11, + double &f12, double &f21, double &f22, double &f31, double &f32, + double &u) { - int i,itable,nr12,nr13,ntheta; - double dr,dtheta; - dr = (pm->mltable->rmax - pm->mltable->rmin)/(pm->mltable->ninput-1); - dtheta = (180.0-0.0)/(pm->mltable->ninput*2); + int i, itable, nr12, nr13, ntheta; + double dr, dtheta; + dr = (pm->mltable->rmax - pm->mltable->rmin) / (pm->mltable->ninput - 1); + dtheta = (180.0 - 0.0) / (pm->mltable->ninput * 2); //lookup scheme // if it is a symmetric threebody interaction, less table entries are required - if (pm->symmetric == true){ - nr12 = (r12 - pm->mltable->rmin + 0.5*dr - 0.00000001)/dr; - if (r12 == (pm->mltable->rmin - 0.5*dr)){ - nr12 = 0; - } - nr13 = (r13 - pm->mltable->rmin + 0.5*dr - 0.00000001)/dr; - if (r13 == (pm->mltable->rmin - 0.5*dr)){ - nr13 = 0; - } + if (pm->symmetric == true) { + nr12 = (r12 - pm->mltable->rmin + 0.5 * dr - 0.00000001) / dr; + if (r12 == (pm->mltable->rmin - 0.5 * dr)) { nr12 = 0; } + nr13 = (r13 - pm->mltable->rmin + 0.5 * dr - 0.00000001) / dr; + if (r13 == (pm->mltable->rmin - 0.5 * dr)) { nr13 = 0; } nr13 -= nr12; - ntheta = (theta-0.00000001)/dtheta; - if (theta == 180.0){ - ntheta = 79; - } + ntheta = (theta - 0.00000001) / dtheta; + if (theta == 180.0) { ntheta = 79; } itable = 0; - for (i=0; imltable->ninput-i); - } + for (i = 0; i < nr12; i++) { itable += (pm->mltable->ninput - i); } itable += nr13; - itable *= (pm->mltable->ninput*2); + itable *= (pm->mltable->ninput * 2); itable += ntheta; } else { // else, more (full) table entries are required - nr12 = (r12 - pm->mltable->rmin + 0.5*dr - 0.00000001)/dr; - if (r12 == (pm->mltable->rmin - 0.5*dr)){ - nr12 = 0; - } - nr13 = (r13 - pm->mltable->rmin + 0.5*dr - 0.00000001)/dr; - if (r13 == (pm->mltable->rmin - 0.5*dr)){ - nr13 = 0; - } - ntheta = (theta-0.00000001)/dtheta; - if (theta == 180.0){ - ntheta = 79; - } - itable = nr12*(pm->mltable->ninput); + nr12 = (r12 - pm->mltable->rmin + 0.5 * dr - 0.00000001) / dr; + if (r12 == (pm->mltable->rmin - 0.5 * dr)) { nr12 = 0; } + nr13 = (r13 - pm->mltable->rmin + 0.5 * dr - 0.00000001) / dr; + if (r13 == (pm->mltable->rmin - 0.5 * dr)) { nr13 = 0; } + ntheta = (theta - 0.00000001) / dtheta; + if (theta == 180.0) { ntheta = 79; } + itable = nr12 * (pm->mltable->ninput); itable += nr13; - itable *= (pm->mltable->ninput*2); + itable *= (pm->mltable->ninput * 2); itable += ntheta; } - f11=pm->mltable->f11file[itable]; - f12=pm->mltable->f12file[itable]; - f21=pm->mltable->f21file[itable]; - f22=pm->mltable->f22file[itable]; - f31=pm->mltable->f31file[itable]; - f32=pm->mltable->f32file[itable]; - u=pm->mltable->efile[itable]; + f11 = pm->mltable->f11file[itable]; + f12 = pm->mltable->f12file[itable]; + f21 = pm->mltable->f21file[itable]; + f22 = pm->mltable->f22file[itable]; + f31 = pm->mltable->f31file[itable]; + f32 = pm->mltable->f32file[itable]; + u = pm->mltable->efile[itable]; } /* ---------------------------------------------------------------------- */ -void PairThreebodyTable::threebody(Param *paramijk, double rsq1, double rsq2, double *delr1, double *delr2, - double *fi, double *fj, double *fk, int eflag, double &eng) +void PairThreebodyTable::threebody(Param *paramijk, double rsq1, double rsq2, double *delr1, + double *delr2, double *fi, double *fj, double *fk, int eflag, + double &eng) { - double r12,r13,theta,rinv,cs; + double r12, r13, theta, rinv, cs; - double f11,f12,f21,f22,f31,f32,u,temp; + double f11, f12, f21, f22, f31, f32, u, temp; bool swapped; double dr; - dr = (paramijk->mltable->rmax - paramijk->mltable->rmin)/(paramijk->mltable->ninput-1); + dr = (paramijk->mltable->rmax - paramijk->mltable->rmin) / (paramijk->mltable->ninput - 1); //if swap indices or not swapped = false; r12 = sqrt(rsq1); r13 = sqrt(rsq2); - rinv = 1.0/(r12*r13); - cs = (delr1[0]*delr2[0] + delr1[1]*delr2[1] + delr1[2]*delr2[2]) * rinv; + rinv = 1.0 / (r12 * r13); + cs = (delr1[0] * delr2[0] + delr1[1] * delr2[1] + delr1[2] * delr2[2]) * rinv; //compute angle between r12 and r13 in degrees - theta = acos(cs)*180.0/MY_PI; + theta = acos(cs) * 180.0 / MY_PI; //if r12 > r13 swap them, as in lookup table always r13 > r12 do to symmetry reasons - if (r12 > r13){ + if (r12 > r13) { temp = r12; r12 = r13; r13 = temp; @@ -787,17 +768,17 @@ void PairThreebodyTable::threebody(Param *paramijk, double rsq1, double rsq2, do //only do lookup and add three-body interactions if r12 and r13 are both between rmin and rmax - if ((r12 >= (paramijk->mltable->rmin - 0.5*dr)) && - (r13 <= (paramijk->mltable->rmax + 0.5*dr)) && - (r13 >= (paramijk->mltable->rmin - 0.5*dr)) && - (r13 <= (paramijk->mltable->rmax + 0.5*dr)) ){ + if ((r12 >= (paramijk->mltable->rmin - 0.5 * dr)) && + (r13 <= (paramijk->mltable->rmax + 0.5 * dr)) && + (r13 >= (paramijk->mltable->rmin - 0.5 * dr)) && + (r13 <= (paramijk->mltable->rmax + 0.5 * dr))) { uf_lookup(paramijk, r12, r13, theta, f11, f12, f21, f22, f31, f32, u); - } else{ + } else { f11 = f12 = f21 = f22 = f31 = f32 = u = 0.0; } // if the indices have been swapped, swap them back - if (swapped == true){ + if (swapped == true) { temp = r12; r12 = r13; r13 = temp; @@ -812,17 +793,17 @@ void PairThreebodyTable::threebody(Param *paramijk, double rsq1, double rsq2, do f32 = -temp; } - fi[0] = delr1[0]*f11+delr2[0]*f12; - fi[1] = delr1[1]*f11+delr2[1]*f12; - fi[2] = delr1[2]*f11+delr2[2]*f12; + fi[0] = delr1[0] * f11 + delr2[0] * f12; + fi[1] = delr1[1] * f11 + delr2[1] * f12; + fi[2] = delr1[2] * f11 + delr2[2] * f12; - fj[0] = delr1[0]*f21+(delr2[0]-delr1[0])*f22; - fj[1] = delr1[1]*f21+(delr2[1]-delr1[1])*f22; - fj[2] = delr1[2]*f21+(delr2[2]-delr1[2])*f22; + fj[0] = delr1[0] * f21 + (delr2[0] - delr1[0]) * f22; + fj[1] = delr1[1] * f21 + (delr2[1] - delr1[1]) * f22; + fj[2] = delr1[2] * f21 + (delr2[2] - delr1[2]) * f22; - fk[0] = delr2[0]*f31+(delr2[0]-delr1[0])*f32; - fk[1] = delr2[1]*f31+(delr2[1]-delr1[1])*f32; - fk[2] = delr2[2]*f31+(delr2[2]-delr1[2])*f32; + fk[0] = delr2[0] * f31 + (delr2[0] - delr1[0]) * f32; + fk[1] = delr2[1] * f31 + (delr2[1] - delr1[1]) * f32; + fk[2] = delr2[2] * f31 + (delr2[2] - delr1[2]) * f32; if (eflag) eng = u; } From 8a055fdcfa3121b4fbba915b4563e66811997ea9 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 1 Jun 2022 15:04:07 -0400 Subject: [PATCH 275/585] merge with third manybody table example and provide updated log files --- examples/PACKAGES/manybody_table/README | 101 +- examples/PACKAGES/manybody_table/in.spce_sw | 20 + .../manybody_table/log.1Jun22.spce.g++.1 | 16 +- .../manybody_table/log.1Jun22.spce.g++.4 | 18 +- .../manybody_table/log.1Jun22.spce2.g++.1 | 18 +- .../manybody_table/log.1Jun22.spce2.g++.4 | 20 +- .../manybody_table/log.1Jun22.spce_sw.g++.1 | 87 ++ .../manybody_table/log.1Jun22.spce_sw.g++.4 | 87 ++ .../spce.sw | 0 .../table_CG_CG_CG.txt | 0 examples/PACKAGES/pair_sw_angle_table/README | 40 - examples/PACKAGES/pair_sw_angle_table/run.sh | 5 - .../PACKAGES/pair_sw_angle_table/spce.data | 1015 -------------- examples/PACKAGES/pair_sw_angle_table/spce.in | 45 - .../pair_sw_angle_table/table_CG_CG.txt | 1203 ----------------- 15 files changed, 276 insertions(+), 2399 deletions(-) create mode 100644 examples/PACKAGES/manybody_table/in.spce_sw create mode 100644 examples/PACKAGES/manybody_table/log.1Jun22.spce_sw.g++.1 create mode 100644 examples/PACKAGES/manybody_table/log.1Jun22.spce_sw.g++.4 rename examples/PACKAGES/{pair_sw_angle_table => manybody_table}/spce.sw (100%) rename examples/PACKAGES/{pair_sw_angle_table => manybody_table}/table_CG_CG_CG.txt (100%) delete mode 100644 examples/PACKAGES/pair_sw_angle_table/README delete mode 100755 examples/PACKAGES/pair_sw_angle_table/run.sh delete mode 100644 examples/PACKAGES/pair_sw_angle_table/spce.data delete mode 100644 examples/PACKAGES/pair_sw_angle_table/spce.in delete mode 100644 examples/PACKAGES/pair_sw_angle_table/table_CG_CG.txt diff --git a/examples/PACKAGES/manybody_table/README b/examples/PACKAGES/manybody_table/README index 3897f80a81..385695e0e0 100644 --- a/examples/PACKAGES/manybody_table/README +++ b/examples/PACKAGES/manybody_table/README @@ -1,65 +1,56 @@ -Example for pair style threebody/table +Three examples inputs for pair styles threebody/table (in.spce and +in.spce2) and sw/angle/table (in.spce_sw). All inputs are for the +simulation of coarse-grained SPC/E water. +A water molecule is represented by one coarse-grained (CG) bead. -This example contains all required input files for the simulation of CG SPC/E water with -the user pair style threebody/table, as well as a run.sh script. - -To run the example, you have to compile LAMMPS with the MANYBODY package, including pair_threebody_table.h and pair_threebody_table.cpp. - -Running the simulations, you will reproduce results of the following publication: - -C. Scherer, R. Scheid, D. Andrienko, and T. Bereau, Kernel-Based Machine Learning for Efficient Simulations of Molecular Liquids, J. Chem. Theor. Comp., 16(5):3194–3204, 2020, https://doi.org/10.1021/acs.jctc.9b01256 - -Here, a water molecule is represented by one coarse-grained (CG) bead. The example contains -two parts. -The three-body (force) tables for both parts (1-1-1.table and 1-1-2.table) have been parametrized with the kernel-based machine learning (ML) with the VOTCA package (https://gitlab.mpcdf.mpg.de/votca/votca). -For a general description of the table format have a look at the documentation of this pair style. -For a example on the parametrization, have a look at https://gitlab.mpcdf.mpg.de/votca/votca/-/tree/master/csg-examples/guide and +For the two threebody/table examples the three-body (force) tables are +in the files 1-1-1.table and 1-1-2.table. These have been parametrized +with the kernel-based machine learning (ML) with the VOTCA package +(https://gitlab.mpcdf.mpg.de/votca/votca). For a example on the +parametrization, have a look at +https://gitlab.mpcdf.mpg.de/votca/votca/-/tree/master/csg-examples/guide +and https://gitlab.mpcdf.mpg.de/votca/votca/-/tree/master/csg-examples/ml. -In both cases, the parametrization is done according to a sample system, using the three-body forces of a Stillinger-Weber potential with tabulated angular forces (sw/angle/table). These then are learned with the covariant meshing technique with the settings files used in https://gitlab.mpcdf.mpg.de/votca/votca/-/tree/master/csg-examples/ml/3body/with_binning. -For the first part of example, the folder contains the contains the LAMMPS data file (spce.data) with the starting configuration of 1000 CG water molecules, an input file (spce.in) and a threebody file (spce.3b). +In both cases, the parametrization is done according to a sample system, +using the three-body forces of a Stillinger-Weber potential with +tabulated angular forces (sw/angle/table) (see in.spce_sw). These then +are learned with the covariant meshing technique with the settings files +used in +https://gitlab.mpcdf.mpg.de/votca/votca/-/tree/master/csg-examples/ml/3body/with_binning. -The lammps input file contains the lines specifying the pair style and coefficients: +The first example, in.spce uses the LAMMPS data file (data.spce) with +the starting configuration of 1000 CG water molecules, and a threebody +file (spce.3b) which loads the 1-1-1.table file. -- pair_style hybrid/overlay table linear 1200 threebody/table - use a combination of pair style table with 1200 linear table entries and the pair style threebody/table -- pair_coeff 1 1 table table_CG_CG.txt VOTCA - set the table name and keyword for the pair style table -- pair_coeff * * threebody/table spce.3b type - set the name of threebody file and bead type for the pair style threebody/table +A hybrid/overlay pair style is used to sum a tabulated pairwise +interaction (table_CG_CG.txt) with the tabulated threebody interactions. +The tabulated pair interaction is the effectively the same as in the +what is used by the in.spce_sw input using sw/angle/table pair style. -A hybrid pair style is used, where pair forces are calculated as a tabulated interaction (table_CG_CG.txt) and the pair style threebody/table is only used to calculate the three-body forces. -The tabulated pair interaction is the same as in the example of the sw/angle/table pair style: examples/PACKAGES/pair_sw_angle_table +IMPORTANT NOTE: The threebody tables are parameterized without storing +energies (the last column of the threebody table files is zero). This +is due to a current limitation of the paramerization procedure. -To run the simulation, one needs an additional threebody file (spce.3b). -It has the following structure: +This in.spce2 example uses the data.spce2 file and the threebody input +spce2.3b. This is essentially the same simulation as in in.spce only +the atom type of the first 100 CG water molecules has been changed from +1 to 2. This is done to demonstrate how to run a simulation with +different atom types. -- type - relates to keyword type in LAMMPS input file -- type - relates to keyword type in LAMMPS input file -- type - relates to keyword type in LAMMPS input file -- 3.7 - cutoff in Ang -- 1-1-1.table - name of 3-body force table -- ENTRY1 - keyword in 3-body force table for this interaction -- linear - interpolation is linear -- 12 - number of grid points in radial direction (automatically sets grid size, in this case to 1872) +For this (artificial) two-element simulation, the threebody file now +contain 8 entries for: type1 type1 type1, type1 type1 type2, type1 type2 +type1, type1 type2 type2, type2 type1 type1, type2 type1 type2, type2 +type2 type1, type2 type2 type2. Each entry has the same structure as +above. However, entries where the second and the third element are +different require a different force table (1-1-2.table) instead of +(1-1-1.table). 1-1-2.table contains exactly the force constants as +1-1-1.table. However it has to have the asymmetric structure where both +interparticle distances (r_ij and r_ik) are varied from rmin to rmax and +therefore contains "M = 2 * N * N * N" (2 * 12 * 12 * 12 = 3456) +entries. -As there is only one atom type (1), the force table is symmetric and contains "M = N * N * (N+1)" (12 * 12 * 13 = 1872) entries. - -The LAMMPS simulation is a standard nvt simulation. A dump file is output with the positions and forces every 10 time steps. -You can calculate the pair distribution and compare it to the ones in the publication. - -For the second part of the example, have a look at the LAMMPS data file (spce_2.data), the input file (spce_2.in) and the threebody file (spce_2.3b). -Running the second part, you will in fact perform the same MD simulation as in the first part of the example. However, the atom type of the first 100 CG water molecules has been changed from 1 to 2. -This is done to demonstrate how to run a simulation with different atom types. - -Again, lammps input file (spce_2.in) contains the lines specifying the pair style and coefficients: - -- pair_style hybrid/overlay table linear 1200 threebody/table - use a combination of pair style table with 1200 linear table entries and the pair style threebody/table -- pair_coeff 1 1 table table_CG_CG.txt VOTCA - set the table name and keyword for the pair style table -- pair_coeff * * threebody/table spce_2.3b type1 type2 - set the name of threebody file and bead type for the pair style threebody/table - -Now, the atom type 1 is mapped to the element type1 and the atom type 2 is mapped to the element type2 in the threebody file (spce_2.3b). -For this (artificial) two-element simulation, the threebody file now contain 8 entries for: type1 type1 type1, type1 type1 type2, type1 type2 type1, type1 type2 type2, type2 type1 type1, type2 type1 type2, type2 type2 type1, type2 type2 type2. -Each entry has the same structure as above. However, entries where the second and the third element are different require a different force table (1-1-2.table) instead of (1-1-1.table). -1-1-2.table contains exactly the force constants as 1-1-1.table. -However it has to have the asymmetric structure where both interparticle distances (r_ij and r_ik) are varied from rmin to rmax and therefore contains "M = 2 * N * N * N" (2 * 12 * 12 * 12 = 3456) entries. - -Now run the simulation. The theromodynamic output, as well as, the pair correlation function should be exactly the same as for the first part of the example. +The third example, in.spce_sw, contains the analytical twobody interactions +and replaces the threebody term of the Stillinger-Weber potential with an +angle/table style potential which is stored in the table_CG_CG_CG.txt file. diff --git a/examples/PACKAGES/manybody_table/in.spce_sw b/examples/PACKAGES/manybody_table/in.spce_sw new file mode 100644 index 0000000000..bb0a097743 --- /dev/null +++ b/examples/PACKAGES/manybody_table/in.spce_sw @@ -0,0 +1,20 @@ +units real +atom_style atomic + +read_data data.spce + +pair_style hybrid/overlay table linear 1200 sw/angle/table + +pair_coeff 1 1 table table_CG_CG.txt VOTCA +pair_coeff * * sw/angle/table spce.sw type + +fix 1 all nvt temp 300.0 300.0 200.0 + +velocity all create 300 432567 dist uniform mom yes + +timestep 2.0 + +thermo 100 +#dump 2 all custom 10 spce_sw.dump id type x y z fx fy fz + +run 1000 diff --git a/examples/PACKAGES/manybody_table/log.1Jun22.spce.g++.1 b/examples/PACKAGES/manybody_table/log.1Jun22.spce.g++.1 index 3489ad5d7a..ec20bd3ced 100644 --- a/examples/PACKAGES/manybody_table/log.1Jun22.spce.g++.1 +++ b/examples/PACKAGES/manybody_table/log.1Jun22.spce.g++.1 @@ -57,20 +57,20 @@ Per MPI rank memory allocation (min/avg/max) = 5.487 | 5.487 | 5.487 Mbytes 800 313.16537 -5466.4124 0 -4533.8594 489.99301 900 303.42954 -5506.3208 0 -4602.7595 360.05608 1000 299.50926 -5446.8981 0 -4555.0107 993.95615 -Loop time of 5.12079 on 1 procs for 1000 steps with 1000 atoms +Loop time of 5.15787 on 1 procs for 1000 steps with 1000 atoms -Performance: 33.745 ns/day, 0.711 hours/ns, 195.282 timesteps/s +Performance: 33.502 ns/day, 0.716 hours/ns, 193.879 timesteps/s 99.7% CPU use with 1 MPI tasks x 1 OpenMP threads MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 4.8109 | 4.8109 | 4.8109 | 0.0 | 93.95 -Neigh | 0.27061 | 0.27061 | 0.27061 | 0.0 | 5.28 -Comm | 0.020092 | 0.020092 | 0.020092 | 0.0 | 0.39 -Output | 0.00020325 | 0.00020325 | 0.00020325 | 0.0 | 0.00 -Modify | 0.011643 | 0.011643 | 0.011643 | 0.0 | 0.23 -Other | | 0.007324 | | | 0.14 +Pair | 4.8428 | 4.8428 | 4.8428 | 0.0 | 93.89 +Neigh | 0.27527 | 0.27527 | 0.27527 | 0.0 | 5.34 +Comm | 0.020461 | 0.020461 | 0.020461 | 0.0 | 0.40 +Output | 0.00020949 | 0.00020949 | 0.00020949 | 0.0 | 0.00 +Modify | 0.01198 | 0.01198 | 0.01198 | 0.0 | 0.23 +Other | | 0.007163 | | | 0.14 Nlocal: 1000 ave 1000 max 1000 min Histogram: 1 0 0 0 0 0 0 0 0 0 diff --git a/examples/PACKAGES/manybody_table/log.1Jun22.spce.g++.4 b/examples/PACKAGES/manybody_table/log.1Jun22.spce.g++.4 index e5985ae51e..48b37d55fe 100644 --- a/examples/PACKAGES/manybody_table/log.1Jun22.spce.g++.4 +++ b/examples/PACKAGES/manybody_table/log.1Jun22.spce.g++.4 @@ -57,20 +57,20 @@ Per MPI rank memory allocation (min/avg/max) = 3.87 | 3.87 | 3.87 Mbytes 800 314.09436 -5467.6073 0 -4532.2879 522.73489 900 300.85843 -5503.7551 0 -4607.85 491.78041 1000 302.84638 -5468.3331 0 -4566.5083 338.05123 -Loop time of 1.45119 on 4 procs for 1000 steps with 1000 atoms +Loop time of 1.60997 on 4 procs for 1000 steps with 1000 atoms -Performance: 119.075 ns/day, 0.202 hours/ns, 689.091 timesteps/s -98.3% CPU use with 4 MPI tasks x 1 OpenMP threads +Performance: 107.331 ns/day, 0.224 hours/ns, 621.131 timesteps/s +94.2% CPU use with 4 MPI tasks x 1 OpenMP threads MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 1.2376 | 1.256 | 1.2833 | 1.5 | 86.55 -Neigh | 0.06865 | 0.06984 | 0.071283 | 0.4 | 4.81 -Comm | 0.084664 | 0.1133 | 0.13329 | 5.4 | 7.81 -Output | 0.0001668 | 0.00034177 | 0.00086454 | 0.0 | 0.02 -Modify | 0.0069024 | 0.0071705 | 0.0074503 | 0.3 | 0.49 -Other | | 0.004489 | | | 0.31 +Pair | 1.28 | 1.2942 | 1.3018 | 0.8 | 80.38 +Neigh | 0.069763 | 0.070222 | 0.070788 | 0.2 | 4.36 +Comm | 0.19379 | 0.20979 | 0.23226 | 3.6 | 13.03 +Output | 0.0001711 | 0.00046947 | 0.0013621 | 0.0 | 0.03 +Modify | 0.021613 | 0.030016 | 0.038718 | 4.8 | 1.86 +Other | | 0.005309 | | | 0.33 Nlocal: 250 ave 257 max 240 min Histogram: 1 0 0 0 0 1 0 0 1 1 diff --git a/examples/PACKAGES/manybody_table/log.1Jun22.spce2.g++.1 b/examples/PACKAGES/manybody_table/log.1Jun22.spce2.g++.1 index 12503118e0..d6432a1c07 100644 --- a/examples/PACKAGES/manybody_table/log.1Jun22.spce2.g++.1 +++ b/examples/PACKAGES/manybody_table/log.1Jun22.spce2.g++.1 @@ -57,20 +57,20 @@ Per MPI rank memory allocation (min/avg/max) = 5.487 | 5.487 | 5.487 Mbytes 800 313.16537 -5466.4124 0 -4533.8594 489.99301 900 303.42954 -5506.3208 0 -4602.7595 360.05608 1000 299.50926 -5446.8981 0 -4555.0107 993.95615 -Loop time of 5.16704 on 1 procs for 1000 steps with 1000 atoms +Loop time of 5.16365 on 1 procs for 1000 steps with 1000 atoms -Performance: 33.443 ns/day, 0.718 hours/ns, 193.534 timesteps/s -99.7% CPU use with 1 MPI tasks x 1 OpenMP threads +Performance: 33.465 ns/day, 0.717 hours/ns, 193.661 timesteps/s +99.8% CPU use with 1 MPI tasks x 1 OpenMP threads MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 4.8574 | 4.8574 | 4.8574 | 0.0 | 94.01 -Neigh | 0.27015 | 0.27015 | 0.27015 | 0.0 | 5.23 -Comm | 0.020112 | 0.020112 | 0.020112 | 0.0 | 0.39 -Output | 0.0002118 | 0.0002118 | 0.0002118 | 0.0 | 0.00 -Modify | 0.011792 | 0.011792 | 0.011792 | 0.0 | 0.23 -Other | | 0.007409 | | | 0.14 +Pair | 4.8443 | 4.8443 | 4.8443 | 0.0 | 93.81 +Neigh | 0.27931 | 0.27931 | 0.27931 | 0.0 | 5.41 +Comm | 0.020302 | 0.020302 | 0.020302 | 0.0 | 0.39 +Output | 0.00022712 | 0.00022712 | 0.00022712 | 0.0 | 0.00 +Modify | 0.011944 | 0.011944 | 0.011944 | 0.0 | 0.23 +Other | | 0.007616 | | | 0.15 Nlocal: 1000 ave 1000 max 1000 min Histogram: 1 0 0 0 0 0 0 0 0 0 diff --git a/examples/PACKAGES/manybody_table/log.1Jun22.spce2.g++.4 b/examples/PACKAGES/manybody_table/log.1Jun22.spce2.g++.4 index 23f3348c34..70fb163b67 100644 --- a/examples/PACKAGES/manybody_table/log.1Jun22.spce2.g++.4 +++ b/examples/PACKAGES/manybody_table/log.1Jun22.spce2.g++.4 @@ -10,7 +10,7 @@ Reading data file ... 1 by 2 by 2 MPI processor grid reading atoms ... 1000 atoms - read_data CPU = 0.002 seconds + read_data CPU = 0.004 seconds pair_style hybrid/overlay table linear 1200 threebody/table @@ -57,20 +57,20 @@ Per MPI rank memory allocation (min/avg/max) = 3.87 | 3.87 | 3.87 Mbytes 800 314.09436 -5467.6073 0 -4532.2879 522.73489 900 300.85843 -5503.7551 0 -4607.85 491.78041 1000 302.84638 -5468.3331 0 -4566.5083 338.05123 -Loop time of 1.4686 on 4 procs for 1000 steps with 1000 atoms +Loop time of 1.54853 on 4 procs for 1000 steps with 1000 atoms -Performance: 117.663 ns/day, 0.204 hours/ns, 680.919 timesteps/s -98.1% CPU use with 4 MPI tasks x 1 OpenMP threads +Performance: 111.590 ns/day, 0.215 hours/ns, 645.773 timesteps/s +96.0% CPU use with 4 MPI tasks x 1 OpenMP threads MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 1.2491 | 1.2757 | 1.3162 | 2.3 | 86.87 -Neigh | 0.06817 | 0.069468 | 0.071025 | 0.5 | 4.73 -Comm | 0.069929 | 0.11236 | 0.14069 | 8.1 | 7.65 -Output | 0.00016417 | 0.00050711 | 0.0015318 | 0.0 | 0.03 -Modify | 0.0057514 | 0.0061681 | 0.0066503 | 0.5 | 0.42 -Other | | 0.004366 | | | 0.30 +Pair | 1.2599 | 1.2908 | 1.3259 | 2.1 | 83.36 +Neigh | 0.069097 | 0.071294 | 0.075502 | 0.9 | 4.60 +Comm | 0.12731 | 0.15884 | 0.19196 | 5.7 | 10.26 +Output | 0.00017674 | 0.0026016 | 0.0098653 | 8.2 | 0.17 +Modify | 0.0093453 | 0.011999 | 0.014575 | 2.3 | 0.77 +Other | | 0.01295 | | | 0.84 Nlocal: 250 ave 257 max 240 min Histogram: 1 0 0 0 0 1 0 0 1 1 diff --git a/examples/PACKAGES/manybody_table/log.1Jun22.spce_sw.g++.1 b/examples/PACKAGES/manybody_table/log.1Jun22.spce_sw.g++.1 new file mode 100644 index 0000000000..e64d577fae --- /dev/null +++ b/examples/PACKAGES/manybody_table/log.1Jun22.spce_sw.g++.1 @@ -0,0 +1,87 @@ +LAMMPS (4 May 2022) + using 1 OpenMP thread(s) per MPI task +units real +atom_style atomic + +read_data data.spce +Reading data file ... + orthogonal box = (0 0 0) to (31.0648 31.0648 31.0648) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 1000 atoms + read_data CPU = 0.001 seconds + +pair_style hybrid/overlay table linear 1200 sw/angle/table + +pair_coeff 1 1 table table_CG_CG.txt VOTCA +pair_coeff * * sw/angle/table spce.sw type + +fix 1 all nvt temp 300.0 300.0 200.0 + +velocity all create 300 432567 dist uniform mom yes + +timestep 2.0 + +thermo 100 +#dump 2 all custom 10 spce_sw.dump id type x y z fx fy fz + +run 1000 +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 14 + ghost atom cutoff = 14 + binsize = 7, bins = 5 5 5 + 2 neighbor lists, perpetual/occasional/extra = 2 0 0 + (1) pair table, perpetual, half/full from (2) + attributes: half, newton on + pair build: halffull/newton + stencil: none + bin: none + (2) pair sw/angle/table, perpetual + attributes: full, newton on + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 5.487 | 5.487 | 5.487 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 300 -4572.9581 0 -3679.6093 -402.23914 + 100 286.5642 -4508.6912 0 -3655.352 -610.63256 + 200 291.59063 -4465.6368 0 -3597.3297 -218.54913 + 300 298.40301 -4460.64 0 -3572.0468 302.96636 + 400 305.99618 -4460.1128 0 -3548.9084 -68.022415 + 500 301.94233 -4440.337 0 -3541.2043 179.36975 + 600 308.95709 -4485.8412 0 -3565.8197 -95.917517 + 700 291.69015 -4489.4465 0 -3620.843 -56.044939 + 800 294.95653 -4496.904 0 -3618.5738 563.3456 + 900 295.50533 -4478.1134 0 -3598.149 89.234288 + 1000 308.63559 -4471.1612 0 -3552.0971 906.33706 +Loop time of 5.39753 on 1 procs for 1000 steps with 1000 atoms + +Performance: 32.015 ns/day, 0.750 hours/ns, 185.270 timesteps/s +99.7% CPU use with 1 MPI tasks x 1 OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 5.0954 | 5.0954 | 5.0954 | 0.0 | 94.40 +Neigh | 0.26201 | 0.26201 | 0.26201 | 0.0 | 4.85 +Comm | 0.020497 | 0.020497 | 0.020497 | 0.0 | 0.38 +Output | 0.00021869 | 0.00021869 | 0.00021869 | 0.0 | 0.00 +Modify | 0.011849 | 0.011849 | 0.011849 | 0.0 | 0.22 +Other | | 0.007577 | | | 0.14 + +Nlocal: 1000 ave 1000 max 1000 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 5862 ave 5862 max 5862 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 191262 ave 191262 max 191262 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +FullNghs: 382524 ave 382524 max 382524 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 382524 +Ave neighs/atom = 382.524 +Neighbor list builds = 26 +Dangerous builds = 0 +Total wall time: 0:00:05 diff --git a/examples/PACKAGES/manybody_table/log.1Jun22.spce_sw.g++.4 b/examples/PACKAGES/manybody_table/log.1Jun22.spce_sw.g++.4 new file mode 100644 index 0000000000..b439b82286 --- /dev/null +++ b/examples/PACKAGES/manybody_table/log.1Jun22.spce_sw.g++.4 @@ -0,0 +1,87 @@ +LAMMPS (4 May 2022) + using 1 OpenMP thread(s) per MPI task +units real +atom_style atomic + +read_data data.spce +Reading data file ... + orthogonal box = (0 0 0) to (31.0648 31.0648 31.0648) + 1 by 2 by 2 MPI processor grid + reading atoms ... + 1000 atoms + read_data CPU = 0.001 seconds + +pair_style hybrid/overlay table linear 1200 sw/angle/table + +pair_coeff 1 1 table table_CG_CG.txt VOTCA +pair_coeff * * sw/angle/table spce.sw type + +fix 1 all nvt temp 300.0 300.0 200.0 + +velocity all create 300 432567 dist uniform mom yes + +timestep 2.0 + +thermo 100 +#dump 2 all custom 10 spce_sw.dump id type x y z fx fy fz + +run 1000 +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 14 + ghost atom cutoff = 14 + binsize = 7, bins = 5 5 5 + 2 neighbor lists, perpetual/occasional/extra = 2 0 0 + (1) pair table, perpetual, half/full from (2) + attributes: half, newton on + pair build: halffull/newton + stencil: none + bin: none + (2) pair sw/angle/table, perpetual + attributes: full, newton on + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 3.87 | 3.87 | 3.87 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 300 -4572.9581 0 -3679.6093 -402.23914 + 100 286.5642 -4508.6912 0 -3655.352 -610.63256 + 200 291.59063 -4465.6368 0 -3597.3297 -218.54913 + 300 298.40301 -4460.64 0 -3572.0468 302.96636 + 400 305.99618 -4460.1128 0 -3548.9084 -68.022415 + 500 301.94233 -4440.337 0 -3541.2043 179.36975 + 600 308.95709 -4485.8412 0 -3565.8197 -95.917517 + 700 291.69015 -4489.4465 0 -3620.843 -56.044939 + 800 294.95653 -4496.904 0 -3618.5738 563.3456 + 900 295.50533 -4478.1134 0 -3598.149 89.234292 + 1000 308.63559 -4471.1612 0 -3552.0971 906.33708 +Loop time of 1.57073 on 4 procs for 1000 steps with 1000 atoms + +Performance: 110.012 ns/day, 0.218 hours/ns, 636.646 timesteps/s +97.1% CPU use with 4 MPI tasks x 1 OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 1.3064 | 1.3347 | 1.3706 | 2.0 | 84.97 +Neigh | 0.065344 | 0.070299 | 0.07737 | 1.7 | 4.48 +Comm | 0.117 | 0.15297 | 0.18685 | 6.5 | 9.74 +Output | 0.00016937 | 0.00055648 | 0.0017097 | 0.0 | 0.04 +Modify | 0.0073414 | 0.0079027 | 0.0085343 | 0.6 | 0.50 +Other | | 0.0043 | | | 0.27 + +Nlocal: 250 ave 254 max 247 min +Histogram: 1 1 0 0 0 1 0 0 0 1 +Nghost: 3473.25 ave 3490 max 3450 min +Histogram: 1 0 0 0 0 1 0 1 0 1 +Neighs: 47815.5 ave 48520 max 47134 min +Histogram: 1 0 1 0 0 0 1 0 0 1 +FullNghs: 95631 ave 97203 max 94083 min +Histogram: 1 0 1 0 0 0 1 0 0 1 + +Total # of neighbors = 382524 +Ave neighs/atom = 382.524 +Neighbor list builds = 26 +Dangerous builds = 0 +Total wall time: 0:00:01 diff --git a/examples/PACKAGES/pair_sw_angle_table/spce.sw b/examples/PACKAGES/manybody_table/spce.sw similarity index 100% rename from examples/PACKAGES/pair_sw_angle_table/spce.sw rename to examples/PACKAGES/manybody_table/spce.sw diff --git a/examples/PACKAGES/pair_sw_angle_table/table_CG_CG_CG.txt b/examples/PACKAGES/manybody_table/table_CG_CG_CG.txt similarity index 100% rename from examples/PACKAGES/pair_sw_angle_table/table_CG_CG_CG.txt rename to examples/PACKAGES/manybody_table/table_CG_CG_CG.txt diff --git a/examples/PACKAGES/pair_sw_angle_table/README b/examples/PACKAGES/pair_sw_angle_table/README deleted file mode 100644 index 54e665ff6c..0000000000 --- a/examples/PACKAGES/pair_sw_angle_table/README +++ /dev/null @@ -1,40 +0,0 @@ -Example for pair style sw/angle/table - - -This example contains all required input files for the simulation of CG SPC/E water with -the user pair style sw/angle/table, as well as a run.sh script. - -To run the example, you have to compile LAMMPS with the MANYBODY package, including pair_sw_angle_table.h and pair_sw_angle_table.cpp. - -Running the simulation, you will reproduce results of the following publication: - -C. Scherer, and D. Andrienko, Understanding three-body contributions to coarse-grained force fields, Phys. Chem. Chem. Phys, 20(34):22387–22394, 2018, http://xlink.rsc.org/?DOI=C8CP00746B - -Here, a water molecule is represented by one coarse-grained (CG) bead. -The two-body (table_CG_CG.txt) and three-body angular (table_CG_CG_CG.txt) interaction potentials have been parametrized with force-matching (FM) with the VOTCA package (https://gitlab.mpcdf.mpg.de/votca/votca). -For more details, have a look at the publication. -For a example on the parametrization, have a look at -https://gitlab.mpcdf.mpg.de/votca/votca/-/tree/master/csg-examples/guide and -https://gitlab.mpcdf.mpg.de/votca/votca/-/tree/master/csg-examples/spce/3body_sw. - -The folder contains the LAMMPS data file (spce.data) with the starting configuration -of 1000 CG water molecules, an input file (spce.in) and a (modified) Stillinger-Weber file (spce.sw). - -The lammps input file contains the lines specifying the pair style and coefficients: - -- pair_style hybrid/overlay table linear 1200 sw/angle/table - use a combination of pair style table with 1200 linear table entries and the pair style sw/angle/table -- pair_coeff 1 1 table table_CG_CG.txt VOTCA - set the table name and keyword for the pair_style table -- pair_coeff * * sw/angle/table spce.sw type - set the name of the Stillinger-Weber file for the pair style sw/angle/table - -A hybrid pair style is used, where pair forces are calculated as a tabulated interaction (table_CG_CG.txt) and the pair style sw/angle/table is only used to calculate the three-body forces. -Therefore, in the Stillinger-Weber file all parameters refering to two-body interactions are set to zero. -As explained in the documentation of this pair style, the .sw file contains the additional lines refering to the tabulated angular potential: - -- table_CG_CG_CG.txt - file name of tabulated angular potential -- VOTCA - keyword for tabulated angular potential -- linear - angular table is of linear style -- 1001 - 1001 table entries - -The LAMMPS simulation is a standard nvt simulation. -A dump file is output with the positions and forces every 10 time steps. -You can calculate the pair distribution and compare it to the one(s) in the publicattion. diff --git a/examples/PACKAGES/pair_sw_angle_table/run.sh b/examples/PACKAGES/pair_sw_angle_table/run.sh deleted file mode 100755 index 8f64855b13..0000000000 --- a/examples/PACKAGES/pair_sw_angle_table/run.sh +++ /dev/null @@ -1,5 +0,0 @@ -#! /bin/bash -e - -#run the LAMMPS simulation (needs a current LAMMPS version compiled with the user pair_style sw/table) -lmp < spce.in > spce.out - diff --git a/examples/PACKAGES/pair_sw_angle_table/spce.data b/examples/PACKAGES/pair_sw_angle_table/spce.data deleted file mode 100644 index a56ab1b10c..0000000000 --- a/examples/PACKAGES/pair_sw_angle_table/spce.data +++ /dev/null @@ -1,1015 +0,0 @@ -Data File for CG Water - -1000 atoms -1 atom types - -0 31.0648 xlo xhi -0 31.0648 ylo yhi -0 31.0648 zlo zhi - -Masses - -1 18.0154 - -Atoms - -1 1 18.26 24.7 15.77 -2 1 12.63 1.42 27.01 -3 1 10.39 29.11 13.56 -4 1 26.47 16.64 7.23 -5 1 10.66 23.41 27.33 -6 1 19.08 3.2 21.63 -7 1 11.17 26.19 1.44 -8 1 4.61 4.04 25.72 -9 1 4.61 22.91 8.33 -10 1 30.61 22.71 25.18 -11 1 6.38 18.92 16.87 -12 1 17.83 12.53 11.09 -13 1 14.89 2.43 22.44 -14 1 28.36 30.9 26.38 -15 1 25.73 28.56 8.32 -16 1 19.61 20.22 4.43 -17 1 25.96 30.32 24.22 -18 1 14.51 17.35 16.41 -19 1 30.23 17.26 10.71 -20 1 22.68 23.23 2.3 -21 1 10.89 15.76 14.33 -22 1 1.46 20.46 12.48 -23 1 12.73 19.57 2.71 -24 1 1.21 12.02 9.88 -25 1 2.63 14.4 23.71 -26 1 16.91 20.37 4.73 -27 1 28.02 7.7 30.08 -28 1 21.22 22.47 19.66 -29 1 14.0 28.15 0.14 -30 1 19.62 19.73 1.11 -31 1 28.29 24.36 10.15 -32 1 14.05 1.1 17.64 -33 1 12.2 23.75 24.83 -34 1 24.56 26.02 13.57 -35 1 12.13 8.39 7.17 -36 1 20.47 22.28 25.02 -37 1 11.06 7.63 24.11 -38 1 6.52 22.64 30.46 -39 1 16.51 24.78 18.58 -40 1 30.18 20.56 29.19 -41 1 25.26 7.8 25.98 -42 1 20.37 4.16 3.88 -43 1 18.85 27.34 27.83 -44 1 17.72 29.84 12.78 -45 1 19.26 14.48 19.38 -46 1 29.73 4.46 4.96 -47 1 9.52 26.27 30.33 -48 1 6.55 9.25 20.32 -49 1 10.49 1.91 23.31 -50 1 17.63 1.17 14.48 -51 1 1.56 25.17 4.69 -52 1 9.08 10.39 2.29 -53 1 25.92 7.4 21.53 -54 1 25.3 5.14 28.4 -55 1 5.63 23.26 19.85 -56 1 9.6 9.85 24.85 -57 1 3.32 2.77 9.12 -58 1 28.54 15.28 22.18 -59 1 20.45 8.24 18.25 -60 1 12.86 3.73 11.61 -61 1 7.42 12.05 13.54 -62 1 1.73 28.54 25.27 -63 1 3.25 22.18 23.7 -64 1 3.27 25.38 2.24 -65 1 13.46 15.67 19.28 -66 1 31.0 6.91 13.61 -67 1 4.85 27.3 12.67 -68 1 24.48 13.52 4.98 -69 1 23.93 29.62 19.71 -70 1 5.03 13.35 19.5 -71 1 24.58 13.46 19.59 -72 1 7.42 6.82 9.03 -73 1 28.76 15.1 3.33 -74 1 12.38 17.21 6.63 -75 1 15.75 21.23 27.02 -76 1 4.58 5.06 28.19 -77 1 26.04 23.3 25.38 -78 1 30.02 7.27 9.52 -79 1 6.93 10.03 24.54 -80 1 5.61 26.93 27.34 -81 1 29.12 19.12 5.54 -82 1 18.44 27.8 14.75 -83 1 14.1 23.13 9.78 -84 1 24.12 5.55 20.72 -85 1 2.52 10.99 18.44 -86 1 1.76 6.41 21.47 -87 1 25.22 9.56 30.66 -88 1 11.87 13.25 9.12 -89 1 19.46 0.3 22.07 -90 1 28.82 12.29 11.36 -91 1 28.47 30.29 14.09 -92 1 25.51 20.94 24.33 -93 1 1.14 25.4 8.76 -94 1 1.33 27.98 3.09 -95 1 20.57 26.97 -0.04 -96 1 22.73 1.18 0.62 -97 1 19.16 16.99 30.52 -98 1 0.39 9.65 9.02 -99 1 4.41 7.21 3.22 -100 1 11.07 30.64 25.91 -101 1 7.93 25.84 26.26 -102 1 26.76 2.51 2.93 -103 1 30.8 18.15 18.49 -104 1 10.2 7.46 30.44 -105 1 4.77 20.39 26.99 -106 1 25.27 26.77 1.64 -107 1 28.51 13.99 9.33 -108 1 13.86 8.04 24.9 -109 1 30.67 29.88 23.01 -110 1 29.49 30.58 30.02 -111 1 28.74 5.08 30.95 -112 1 13.21 4.31 30.96 -113 1 5.27 3.66 5.02 -114 1 29.43 7.99 17.07 -115 1 4.19 1.37 16.63 -116 1 1.27 27.81 16.56 -117 1 30.64 5.73 25.91 -118 1 10.33 5.33 26.48 -119 1 11.56 21.77 14.77 -120 1 26.46 27.17 5.7 -121 1 14.85 25.79 8.64 -122 1 22.62 6.18 17.61 -123 1 3.45 18.53 11.84 -124 1 11.65 18.17 15.97 -125 1 23.16 17.0 1.5 -126 1 18.92 16.01 3.98 -127 1 30.05 0.25 5.23 -128 1 26.06 11.96 21.96 -129 1 16.82 2.0 10.25 -130 1 19.58 2.63 24.75 -131 1 20.09 14.75 26.62 -132 1 3.14 0.05 26.13 -133 1 4.86 11.79 12.99 -134 1 1.86 11.32 28.57 -135 1 8.82 28.6 6.22 -136 1 20.85 24.68 23.87 -137 1 7.58 25.15 3.44 -138 1 23.46 9.13 8.11 -139 1 6.45 10.24 27.37 -140 1 15.06 10.35 26.71 -141 1 13.8 18.39 26.5 -142 1 5.11 7.7 5.83 -143 1 23.27 23.16 6.67 -144 1 6.33 1.31 11.37 -145 1 14.66 22.28 21.43 -146 1 7.9 8.65 0.61 -147 1 21.83 3.67 26.17 -148 1 1.41 23.66 11.09 -149 1 10.19 17.23 22.71 -150 1 29.53 27.31 23.19 -151 1 28.69 11.38 2.33 -152 1 1.07 2.97 14.53 -153 1 23.47 30.53 14.32 -154 1 1.59 18.83 14.75 -155 1 20.38 30.6 24.38 -156 1 19.81 29.95 27.9 -157 1 12.68 27.59 26.46 -158 1 20.46 9.14 29.06 -159 1 8.69 13.98 24.71 -160 1 0.72 9.29 30.28 -161 1 11.81 20.55 12.28 -162 1 23.8 13.8 9.4 -163 1 13.63 0.51 0.95 -164 1 2.33 6.68 14.95 -165 1 15.98 6.35 25.28 -166 1 7.38 14.88 18.44 -167 1 17.07 20.48 29.16 -168 1 14.53 1.49 8.4 -169 1 28.45 1.21 20.58 -170 1 0.07 5.28 29.45 -171 1 26.0 9.98 15.37 -172 1 14.56 6.91 14.46 -173 1 20.6 9.09 23.04 -174 1 26.02 4.59 0.14 -175 1 5.21 21.9 17.55 -176 1 2.44 7.72 1.47 -177 1 1.25 30.0 13.48 -178 1 27.27 23.13 14.61 -179 1 24.04 15.61 21.64 -180 1 25.13 5.24 17.43 -181 1 4.2 15.98 12.34 -182 1 26.92 13.54 12.87 -183 1 3.38 19.38 9.08 -184 1 27.75 25.03 2.15 -185 1 26.13 20.68 16.54 -186 1 8.3 14.6 13.49 -187 1 3.04 22.87 29.93 -188 1 9.5 26.41 21.23 -189 1 6.53 2.16 2.75 -190 1 6.37 29.04 2.63 -191 1 26.58 4.38 19.69 -192 1 28.44 6.56 14.66 -193 1 25.55 11.1 28.03 -194 1 25.5 18.39 28.73 -195 1 27.67 23.47 5.65 -196 1 13.69 14.81 16.17 -197 1 22.97 27.61 24.11 -198 1 2.06 18.58 30.22 -199 1 2.07 7.13 29.2 -200 1 13.0 7.26 17.76 -201 1 10.04 16.22 30.62 -202 1 6.54 9.8 17.47 -203 1 5.65 12.68 0.64 -204 1 20.84 20.25 23.02 -205 1 22.48 27.63 21.48 -206 1 15.61 22.73 5.36 -207 1 3.52 30.36 6.24 -208 1 6.38 17.25 26.36 -209 1 14.13 10.57 22.63 -210 1 10.22 25.11 3.64 -211 1 16.63 14.7 25.08 -212 1 3.51 29.69 2.76 -213 1 19.2 11.9 21.44 -214 1 30.8 23.85 14.75 -215 1 21.02 14.34 12.4 -216 1 2.75 22.13 27.29 -217 1 29.27 14.29 6.8 -218 1 8.44 20.67 5.23 -219 1 9.42 20.06 22.95 -220 1 30.83 10.64 19.73 -221 1 19.33 14.14 8.94 -222 1 14.18 11.32 18.19 -223 1 26.55 2.39 28.55 -224 1 6.83 16.57 8.9 -225 1 13.98 8.79 1.97 -226 1 4.94 3.0 23.16 -227 1 25.39 29.46 0.63 -228 1 15.32 16.43 2.45 -229 1 5.26 29.73 29.87 -230 1 26.92 14.84 19.93 -231 1 11.87 30.08 4.52 -232 1 7.17 6.71 2.23 -233 1 10.46 1.13 18.11 -234 1 28.59 20.57 25.68 -235 1 26.54 4.84 8.44 -236 1 16.46 18.37 26.15 -237 1 30.53 0.74 15.31 -238 1 27.25 6.31 27.09 -239 1 22.42 1.65 3.87 -240 1 17.85 3.77 8.02 -241 1 11.82 8.23 11.15 -242 1 8.62 27.66 15.87 -243 1 25.19 1.89 18.37 -244 1 14.0 21.96 30.21 -245 1 29.3 1.73 28.29 -246 1 9.35 24.02 12.03 -247 1 1.05 21.5 0.35 -248 1 21.87 20.54 2.54 -249 1 10.59 15.98 17.51 -250 1 22.76 6.0 9.32 -251 1 0.31 9.13 11.87 -252 1 29.16 25.13 18.29 -253 1 1.23 29.08 7.75 -254 1 30.01 28.49 26.21 -255 1 1.87 5.92 5.03 -256 1 1.15 10.27 22.35 -257 1 11.83 10.31 5.16 -258 1 20.89 8.28 8.14 -259 1 13.48 11.78 28.37 -260 1 6.82 10.48 10.25 -261 1 7.34 4.49 18.73 -262 1 5.49 22.37 14.23 -263 1 12.31 21.05 27.47 -264 1 24.09 17.4 8.65 -265 1 22.03 11.54 20.98 -266 1 16.68 13.17 0.68 -267 1 5.52 1.47 8.78 -268 1 14.95 11.83 7.95 -269 1 5.9 10.66 7.12 -270 1 10.06 11.28 30.73 -271 1 17.72 10.71 27.46 -272 1 13.6 6.23 10.82 -273 1 23.42 30.72 9.31 -274 1 23.27 4.25 3.8 -275 1 13.79 8.37 21.07 -276 1 5.01 30.13 12.61 -277 1 26.04 24.45 17.25 -278 1 22.59 14.31 0.81 -279 1 23.74 10.37 17.17 -280 1 23.4 8.52 12.55 -281 1 10.53 23.97 21.96 -282 1 0.69 13.92 28.42 -283 1 6.94 6.27 15.01 -284 1 29.8 20.92 3.41 -285 1 10.19 20.68 19.0 -286 1 26.38 25.4 28.89 -287 1 12.34 26.9 8.27 -288 1 15.0 7.69 6.4 -289 1 24.75 13.1 2.24 -290 1 4.5 20.58 6.78 -291 1 23.27 18.25 11.48 -292 1 25.92 26.39 22.66 -293 1 24.63 4.21 6.52 -294 1 16.68 15.05 15.6 -295 1 26.39 16.17 29.89 -296 1 10.12 6.21 8.63 -297 1 14.41 14.67 12.23 -298 1 19.59 3.47 1.47 -299 1 28.21 22.43 18.25 -300 1 27.87 29.74 11.47 -301 1 22.53 24.1 13.94 -302 1 12.55 1.58 29.82 -303 1 17.45 21.28 8.34 -304 1 16.3 10.75 16.22 -305 1 16.34 13.25 17.65 -306 1 8.44 4.52 0.93 -307 1 17.47 23.79 2.3 -308 1 29.04 26.8 5.13 -309 1 13.13 11.34 24.9 -310 1 24.33 13.0 13.32 -311 1 8.21 29.74 24.23 -312 1 21.79 28.0 5.85 -313 1 13.74 20.08 10.26 -314 1 20.92 24.38 6.01 -315 1 9.83 29.56 17.99 -316 1 26.66 30.76 2.95 -317 1 24.34 3.08 1.67 -318 1 28.09 10.69 23.33 -319 1 7.08 25.28 0.77 -320 1 15.34 1.12 29.82 -321 1 26.07 12.55 7.74 -322 1 16.85 0.81 21.24 -323 1 9.96 0.57 6.36 -324 1 29.4 2.54 1.18 -325 1 5.81 1.0 5.42 -326 1 25.16 24.89 11.15 -327 1 15.43 24.93 13.71 -328 1 24.6 10.06 10.58 -329 1 20.4 12.04 15.51 -330 1 15.72 18.9 0.21 -331 1 16.5 17.21 28.81 -332 1 16.79 3.11 12.74 -333 1 22.75 6.22 6.6 -334 1 8.09 19.86 30.92 -335 1 24.15 8.75 23.65 -336 1 12.24 30.51 15.39 -337 1 8.15 26.8 18.69 -338 1 0.1 15.0 15.49 -339 1 29.84 15.71 30.0 -340 1 15.39 18.25 11.17 -341 1 1.2 15.49 18.8 -342 1 27.55 9.81 17.9 -343 1 18.93 8.9 10.06 -344 1 28.35 12.36 4.82 -345 1 11.21 13.71 30.62 -346 1 2.5 16.67 16.33 -347 1 0.47 4.2 6.99 -348 1 23.72 4.38 12.28 -349 1 16.59 3.54 16.9 -350 1 17.31 17.81 15.8 -351 1 11.58 0.3 21.21 -352 1 23.67 21.91 15.84 -353 1 7.74 2.78 23.52 -354 1 14.34 9.65 4.52 -355 1 23.35 10.88 14.55 -356 1 3.51 10.03 20.99 -357 1 14.63 21.34 1.75 -358 1 24.37 8.39 2.96 -359 1 14.8 15.5 30.48 -360 1 2.59 1.32 12.76 -361 1 0.16 13.81 25.49 -362 1 11.26 10.11 27.84 -363 1 27.8 18.65 15.07 -364 1 5.07 5.43 21.33 -365 1 14.06 5.26 19.67 -366 1 3.76 18.23 19.36 -367 1 26.68 27.25 10.67 -368 1 7.72 19.58 13.64 -369 1 29.48 16.94 16.45 -370 1 28.18 13.38 30.28 -371 1 29.97 10.41 16.17 -372 1 11.97 28.73 29.31 -373 1 14.88 0.79 25.43 -374 1 8.98 23.85 7.66 -375 1 4.78 8.21 9.79 -376 1 21.74 20.61 28.64 -377 1 20.36 18.75 17.92 -378 1 12.61 21.65 23.18 -379 1 6.36 29.76 8.49 -380 1 12.51 26.69 18.69 -381 1 22.2 17.41 6.86 -382 1 11.7 6.53 21.66 -383 1 4.62 16.22 3.24 -384 1 0.76 13.73 0.83 -385 1 21.91 13.43 5.67 -386 1 17.36 6.16 4.12 -387 1 0.34 28.1 11.89 -388 1 2.43 26.92 20.47 -389 1 0.99 22.41 4.14 -390 1 23.77 24.66 24.16 -391 1 22.41 7.79 20.57 -392 1 16.4 22.82 23.46 -393 1 24.68 28.28 17.44 -394 1 14.99 26.21 27.12 -395 1 0.75 13.41 7.7 -396 1 16.43 5.69 21.09 -397 1 19.5 6.71 27.89 -398 1 14.32 17.4 22.9 -399 1 29.04 27.81 19.17 -400 1 9.52 19.68 10.69 -401 1 5.33 27.17 17.3 -402 1 5.2 12.64 9.11 -403 1 9.8 6.14 19.74 -404 1 9.86 22.71 1.2 -405 1 0.84 12.31 14.9 -406 1 18.79 12.07 17.76 -407 1 27.21 25.79 14.27 -408 1 6.11 1.01 19.83 -409 1 8.44 5.68 12.85 -410 1 22.42 26.4 1.81 -411 1 24.0 20.11 18.63 -412 1 2.32 26.11 12.18 -413 1 26.06 7.28 15.77 -414 1 9.96 9.13 19.49 -415 1 10.74 12.01 25.79 -416 1 30.39 1.07 11.77 -417 1 9.49 20.19 26.63 -418 1 15.99 30.59 6.78 -419 1 11.0 30.74 0.96 -420 1 23.67 30.14 22.75 -421 1 24.14 9.9 19.82 -422 1 5.88 5.5 7.25 -423 1 3.45 10.72 9.52 -424 1 11.78 25.26 29.31 -425 1 15.95 27.28 17.71 -426 1 17.99 16.5 8.95 -427 1 28.47 0.47 23.29 -428 1 14.06 1.39 12.17 -429 1 19.28 23.85 8.27 -430 1 13.62 4.42 14.21 -431 1 2.98 9.89 12.04 -432 1 7.35 14.53 10.79 -433 1 15.55 0.87 3.17 -434 1 7.7 24.24 23.88 -435 1 17.61 8.64 6.93 -436 1 5.17 26.9 3.74 -437 1 1.06 17.17 27.8 -438 1 18.8 9.64 19.81 -439 1 8.36 1.64 0.63 -440 1 13.68 14.97 7.75 -441 1 29.56 0.55 17.98 -442 1 3.01 24.45 14.3 -443 1 11.98 7.48 26.92 -444 1 19.13 24.44 27.57 -445 1 11.75 14.57 11.88 -446 1 13.1 4.54 22.64 -447 1 7.2 21.26 28.21 -448 1 24.85 22.96 28.77 -449 1 15.0 23.95 16.32 -450 1 24.6 14.43 15.56 -451 1 3.05 13.66 17.69 -452 1 3.0 3.39 6.37 -453 1 24.92 22.04 13.42 -454 1 21.24 2.56 17.68 -455 1 19.69 0.3 11.75 -456 1 5.73 29.89 26.41 -457 1 7.62 30.1 0.37 -458 1 14.62 28.23 20.86 -459 1 8.72 5.14 23.94 -460 1 9.94 25.78 9.45 -461 1 17.3 4.53 0.74 -462 1 17.58 12.58 14.58 -463 1 8.64 2.55 20.15 -464 1 21.07 10.96 26.32 -465 1 27.85 4.23 10.9 -466 1 20.41 29.07 20.84 -467 1 9.35 12.65 10.7 -468 1 9.88 0.73 3.41 -469 1 26.64 20.78 1.33 -470 1 25.47 19.72 10.96 -471 1 1.01 5.01 12.19 -472 1 10.11 27.98 23.8 -473 1 17.51 0.24 28.51 -474 1 21.85 14.89 8.07 -475 1 18.22 12.88 29.4 -476 1 10.97 16.02 2.55 -477 1 4.3 25.33 5.86 -478 1 12.67 27.62 3.28 -479 1 12.18 24.26 16.74 -480 1 0.24 29.32 20.41 -481 1 5.03 15.5 6.14 -482 1 11.11 12.43 6.7 -483 1 10.14 4.47 15.0 -484 1 2.9 6.91 24.11 -485 1 30.6 4.29 16.4 -486 1 9.61 4.66 29.44 -487 1 5.38 17.6 1.1 -488 1 3.71 5.22 11.92 -489 1 8.93 11.33 8.19 -490 1 31.02 28.82 0.48 -491 1 0.81 2.74 23.14 -492 1 16.45 28.36 8.16 -493 1 2.1 8.36 17.2 -494 1 25.82 16.89 1.44 -495 1 20.21 11.2 11.56 -496 1 13.88 23.42 27.01 -497 1 30.15 5.56 2.54 -498 1 1.76 17.51 24.41 -499 1 18.18 8.62 16.29 -500 1 4.41 20.18 15.26 -501 1 7.05 29.39 19.64 -502 1 22.92 21.56 26.41 -503 1 29.43 3.25 12.91 -504 1 16.92 25.1 29.07 -505 1 25.4 12.48 17.22 -506 1 7.4 5.74 28.39 -507 1 0.14 3.32 27.06 -508 1 29.61 24.31 3.76 -509 1 13.25 25.77 23.43 -510 1 19.18 28.02 24.33 -511 1 3.66 10.37 26.9 -512 1 12.53 11.26 1.28 -513 1 28.21 7.27 11.49 -514 1 26.9 9.35 3.39 -515 1 18.87 28.09 9.36 -516 1 9.3 30.5 15.62 -517 1 12.34 13.23 3.13 -518 1 27.93 26.52 26.46 -519 1 7.78 9.29 14.0 -520 1 16.12 6.82 1.73 -521 1 0.63 2.82 20.33 -522 1 12.2 26.56 13.2 -523 1 6.16 16.1 15.43 -524 1 13.49 24.29 6.85 -525 1 28.61 10.73 30.64 -526 1 19.98 17.97 5.68 -527 1 2.75 19.83 4.73 -528 1 18.41 26.18 2.29 -529 1 22.35 24.43 11.05 -530 1 4.45 4.92 15.13 -531 1 16.8 18.43 21.99 -532 1 2.08 4.57 24.87 -533 1 26.03 2.02 24.82 -534 1 15.65 30.12 19.2 -535 1 27.88 13.79 27.66 -536 1 29.03 7.86 2.9 -537 1 2.68 5.55 9.4 -538 1 30.45 11.98 23.35 -539 1 2.08 19.71 21.15 -540 1 11.06 3.11 4.38 -541 1 21.61 14.28 20.83 -542 1 15.85 5.82 12.29 -543 1 29.7 22.61 8.47 -544 1 29.5 7.81 27.38 -545 1 24.12 20.22 0.4 -546 1 16.0 25.22 21.34 -547 1 19.8 25.24 13.43 -548 1 7.11 16.71 4.39 -549 1 4.59 0.13 21.8 -550 1 20.94 12.01 28.92 -551 1 12.99 2.09 6.04 -552 1 19.45 19.38 14.86 -553 1 12.98 23.9 12.88 -554 1 13.06 12.04 20.67 -555 1 17.56 1.18 25.76 -556 1 29.88 16.58 1.42 -557 1 6.04 13.87 25.34 -558 1 25.5 6.08 10.63 -559 1 20.34 11.15 2.51 -560 1 3.82 11.92 15.57 -561 1 10.47 18.64 8.01 -562 1 13.02 24.92 20.67 -563 1 20.03 29.78 7.22 -564 1 8.36 11.63 28.63 -565 1 14.06 21.56 15.74 -566 1 9.4 28.78 29.81 -567 1 9.07 10.18 22.15 -568 1 11.47 22.66 29.81 -569 1 17.02 8.02 27.19 -570 1 29.56 18.32 21.38 -571 1 8.58 8.58 11.23 -572 1 22.15 19.86 15.25 -573 1 12.34 29.83 7.16 -574 1 20.52 25.35 20.66 -575 1 21.23 5.6 23.05 -576 1 23.45 10.69 5.93 -577 1 14.15 4.81 4.29 -578 1 8.26 24.58 28.88 -579 1 10.03 3.4 7.88 -580 1 25.65 7.23 0.84 -581 1 7.28 26.7 9.09 -582 1 20.47 29.31 16.02 -583 1 4.44 7.7 27.1 -584 1 27.95 23.13 0.39 -585 1 19.82 18.98 12.12 -586 1 20.01 5.07 14.72 -587 1 1.66 1.23 5.19 -588 1 5.6 11.21 22.59 -589 1 3.81 22.68 4.63 -590 1 17.47 14.06 22.25 -591 1 16.77 22.61 10.71 -592 1 7.2 26.5 22.52 -593 1 10.75 17.97 28.76 -594 1 16.61 8.28 20.88 -595 1 0.81 27.72 28.37 -596 1 6.78 22.71 4.37 -597 1 27.35 28.79 17.13 -598 1 15.16 3.34 2.07 -599 1 19.69 29.89 30.66 -600 1 17.34 20.23 2.18 -601 1 15.65 15.76 9.8 -602 1 19.07 19.02 8.23 -603 1 26.13 0.42 7.37 -604 1 4.29 9.29 15.94 -605 1 7.86 7.42 4.84 -606 1 23.4 1.93 16.16 -607 1 5.27 27.16 0.17 -608 1 27.08 14.52 1.58 -609 1 8.34 11.25 18.53 -610 1 10.4 17.83 12.7 -611 1 8.86 18.1 18.73 -612 1 17.69 22.57 26.0 -613 1 6.1 6.61 11.68 -614 1 24.32 13.38 23.99 -615 1 0.13 20.78 22.53 -616 1 10.96 20.82 6.33 -617 1 28.46 1.62 7.03 -618 1 16.9 4.13 23.44 -619 1 1.89 11.75 5.82 -620 1 3.27 20.91 2.26 -621 1 11.14 15.5 24.78 -622 1 21.76 3.5 20.99 -623 1 3.95 12.22 24.49 -624 1 7.26 23.31 16.11 -625 1 19.28 20.97 21.06 -626 1 7.2 17.22 22.12 -627 1 16.26 10.81 24.17 -628 1 1.54 24.72 17.86 -629 1 17.74 0.11 1.5 -630 1 25.85 5.87 23.82 -631 1 4.21 7.73 13.47 -632 1 20.87 8.0 25.94 -633 1 22.23 3.22 8.98 -634 1 13.72 30.72 23.05 -635 1 4.91 26.26 19.85 -636 1 14.82 27.52 13.76 -637 1 27.5 3.72 26.36 -638 1 27.62 9.82 10.27 -639 1 19.32 8.78 3.53 -640 1 16.33 28.86 1.39 -641 1 30.26 10.13 4.93 -642 1 14.94 29.37 4.67 -643 1 7.61 12.27 21.0 -644 1 5.31 18.92 23.16 -645 1 25.19 3.1 14.51 -646 1 8.12 21.6 9.56 -647 1 20.35 17.71 23.89 -648 1 3.39 19.78 24.7 -649 1 5.42 23.52 1.93 -650 1 29.44 5.52 23.47 -651 1 23.83 22.25 20.16 -652 1 17.93 4.41 19.13 -653 1 9.44 1.91 29.19 -654 1 29.91 23.65 12.09 -655 1 27.06 21.35 3.96 -656 1 16.28 19.92 14.78 -657 1 19.99 5.38 17.54 -658 1 14.54 21.16 7.89 -659 1 26.09 14.97 10.68 -660 1 0.63 24.05 28.89 -661 1 5.07 25.73 10.62 -662 1 6.78 8.27 29.12 -663 1 11.86 12.77 15.67 -664 1 21.83 14.26 24.49 -665 1 23.7 1.53 6.32 -666 1 28.91 27.7 13.19 -667 1 16.46 28.92 23.22 -668 1 26.22 15.29 23.65 -669 1 23.75 1.5 21.21 -670 1 4.08 23.38 11.4 -671 1 29.4 29.73 2.7 -672 1 8.94 16.2 27.64 -673 1 30.79 23.65 6.33 -674 1 27.04 17.6 10.45 -675 1 21.48 15.71 29.11 -676 1 17.68 22.29 18.33 -677 1 22.1 29.54 1.71 -678 1 16.17 27.33 3.65 -679 1 9.22 5.24 5.71 -680 1 1.81 4.91 1.83 -681 1 30.98 28.61 5.42 -682 1 0.24 6.26 18.55 -683 1 17.39 24.85 11.97 -684 1 28.21 20.4 22.88 -685 1 23.01 8.35 29.39 -686 1 4.03 15.76 25.76 -687 1 3.89 12.75 4.32 -688 1 16.42 9.73 9.22 -689 1 14.74 17.01 13.68 -690 1 11.65 22.66 10.77 -691 1 21.04 26.56 25.76 -692 1 3.97 29.83 10.01 -693 1 10.62 26.12 25.57 -694 1 17.97 8.53 23.31 -695 1 19.22 16.46 13.24 -696 1 2.39 24.13 25.42 -697 1 1.72 21.99 14.71 -698 1 14.16 25.55 4.52 -699 1 10.58 12.26 13.38 -700 1 25.76 29.55 5.46 -701 1 24.18 1.25 26.8 -702 1 30.61 26.16 30.37 -703 1 3.38 16.05 28.52 -704 1 1.18 24.43 20.96 -705 1 7.9 1.26 25.66 -706 1 26.57 10.39 5.82 -707 1 8.44 8.09 16.34 -708 1 16.67 27.55 25.72 -709 1 7.45 2.82 7.35 -710 1 19.18 19.09 28.22 -711 1 12.68 8.88 30.58 -712 1 27.98 26.24 30.75 -713 1 11.84 28.3 20.75 -714 1 10.45 30.97 11.14 -715 1 8.96 2.33 11.92 -716 1 7.66 10.26 5.22 -717 1 23.5 12.98 28.85 -718 1 30.48 8.08 21.02 -719 1 16.48 29.96 10.33 -720 1 13.88 5.72 8.08 -721 1 27.47 28.22 21.47 -722 1 26.74 18.07 22.5 -723 1 25.13 23.78 0.9 -724 1 29.21 15.71 26.07 -725 1 19.41 3.92 10.58 -726 1 24.96 7.64 5.7 -727 1 7.44 14.1 29.85 -728 1 7.13 12.21 3.18 -729 1 16.35 14.7 4.18 -730 1 1.43 15.6 11.58 -731 1 30.27 1.93 9.17 -732 1 2.77 2.54 27.69 -733 1 11.36 27.83 16.39 -734 1 7.83 2.36 14.66 -735 1 19.3 12.28 5.63 -736 1 28.36 12.19 19.25 -737 1 10.67 7.34 13.62 -738 1 26.6 24.47 21.0 -739 1 8.55 29.42 27.3 -740 1 25.79 25.13 4.07 -741 1 28.21 8.09 22.88 -742 1 22.44 11.07 23.78 -743 1 27.76 17.89 25.74 -744 1 2.23 0.19 23.48 -745 1 10.49 12.99 20.29 -746 1 18.74 11.84 24.74 -747 1 29.46 2.69 24.54 -748 1 3.11 29.29 15.2 -749 1 21.8 19.07 20.45 -750 1 11.21 17.26 20.08 -751 1 2.59 26.55 26.79 -752 1 23.67 25.82 17.79 -753 1 23.43 27.91 15.08 -754 1 6.86 2.11 28.13 -755 1 14.38 19.97 19.61 -756 1 29.05 26.41 8.62 -757 1 3.34 9.63 6.81 -758 1 21.41 30.88 18.45 -759 1 30.35 16.75 23.77 -760 1 19.92 6.73 20.92 -761 1 26.4 1.5 11.47 -762 1 16.6 8.88 30.96 -763 1 23.25 29.76 4.34 -764 1 17.15 13.45 7.34 -765 1 14.52 14.34 23.37 -766 1 11.77 3.31 25.06 -767 1 15.52 25.25 0.94 -768 1 21.53 27.39 12.97 -769 1 11.29 10.11 17.38 -770 1 11.07 15.06 5.47 -771 1 27.61 7.39 6.07 -772 1 15.82 4.83 27.63 -773 1 17.16 20.28 12.25 -774 1 3.18 28.03 22.92 -775 1 25.53 27.61 25.22 -776 1 1.81 16.55 1.25 -777 1 3.72 16.82 7.97 -778 1 7.68 21.57 2.11 -779 1 21.85 26.93 28.36 -780 1 10.31 8.57 4.0 -781 1 11.61 9.88 14.35 -782 1 0.41 8.48 24.13 -783 1 3.8 10.63 30.74 -784 1 2.74 17.0 21.82 -785 1 28.44 22.73 28.74 -786 1 2.08 0.43 20.23 -787 1 0.25 9.36 2.02 -788 1 27.68 11.33 26.53 -789 1 27.63 4.1 14.74 -790 1 19.68 0.89 3.22 -791 1 17.12 30.74 17.17 -792 1 16.11 25.62 24.01 -793 1 20.49 9.58 13.85 -794 1 26.77 20.78 27.64 -795 1 18.77 16.87 25.93 -796 1 7.01 13.49 6.76 -797 1 18.38 16.84 18.4 -798 1 8.54 14.44 4.51 -799 1 11.51 1.42 8.98 -800 1 17.06 14.93 12.29 -801 1 6.07 0.24 15.08 -802 1 8.76 17.53 2.01 -803 1 19.63 6.58 1.71 -804 1 10.24 4.66 10.93 -805 1 4.39 20.15 30.88 -806 1 30.31 16.7 6.24 -807 1 26.0 30.16 27.34 -808 1 6.44 21.42 21.88 -809 1 22.05 29.62 11.43 -810 1 21.94 22.11 9.22 -811 1 21.82 1.59 13.13 -812 1 27.09 0.55 16.64 -813 1 8.88 3.09 17.06 -814 1 6.95 18.85 6.3 -815 1 20.13 2.53 15.07 -816 1 17.52 12.36 3.26 -817 1 18.46 7.24 13.99 -818 1 12.61 6.94 3.36 -819 1 15.55 17.46 19.11 -820 1 16.13 27.37 11.33 -821 1 2.99 14.41 9.34 -822 1 5.81 22.26 24.67 -823 1 19.82 2.53 6.19 -824 1 28.93 5.65 7.69 -825 1 17.89 22.05 15.68 -826 1 5.63 7.81 23.81 -827 1 19.09 16.3 22.05 -828 1 1.07 19.82 27.06 -829 1 14.74 8.15 28.71 -830 1 16.98 10.27 4.92 -831 1 13.39 20.01 5.47 -832 1 21.23 3.56 30.15 -833 1 29.23 18.12 28.24 -834 1 16.76 24.31 7.29 -835 1 26.12 21.8 21.5 -836 1 0.2 13.1 12.25 -837 1 1.99 3.78 30.39 -838 1 26.67 20.02 19.27 -839 1 20.63 10.01 5.91 -840 1 4.44 3.74 1.84 -841 1 21.95 6.78 0.24 -842 1 9.86 22.51 17.05 -843 1 26.17 7.64 18.91 -844 1 17.09 20.11 19.78 -845 1 10.38 9.07 9.16 -846 1 9.92 13.21 17.39 -847 1 24.26 19.17 3.05 -848 1 13.32 18.96 29.06 -849 1 27.98 20.32 7.7 -850 1 10.35 6.44 17.04 -851 1 27.27 28.95 29.77 -852 1 7.71 19.32 24.95 -853 1 23.11 17.51 14.39 -854 1 25.37 14.39 26.26 -855 1 4.73 3.99 17.92 -856 1 28.53 17.74 8.3 -857 1 28.99 9.49 7.65 -858 1 11.37 3.77 18.66 -859 1 11.01 23.57 6.0 -860 1 7.29 17.47 30.27 -861 1 18.92 10.24 0.36 -862 1 22.76 24.44 27.3 -863 1 14.27 13.05 5.04 -864 1 3.42 14.59 30.9 -865 1 9.31 22.34 24.75 -866 1 25.78 16.96 15.63 -867 1 7.18 22.01 12.25 -868 1 5.0 18.29 28.57 -869 1 23.36 20.87 22.7 -870 1 13.16 10.8 10.17 -871 1 6.42 24.78 7.47 -872 1 28.86 3.89 20.92 -873 1 4.8 3.05 13.07 -874 1 27.07 3.53 5.63 -875 1 13.11 28.33 23.92 -876 1 14.84 13.88 20.8 -877 1 15.81 7.0 16.91 -878 1 23.41 25.39 20.56 -879 1 26.08 0.43 14.19 -880 1 6.28 17.41 19.28 -881 1 2.74 4.79 19.54 -882 1 20.98 26.42 10.11 -883 1 24.18 28.48 29.18 -884 1 12.74 29.99 12.8 -885 1 27.22 16.82 18.13 -886 1 2.08 19.98 18.27 -887 1 22.0 23.67 17.16 -888 1 17.83 3.01 29.13 -889 1 9.59 26.62 13.51 -890 1 11.48 2.18 13.45 -891 1 13.57 15.29 26.47 -892 1 1.72 0.72 9.92 -893 1 2.14 30.76 17.27 -894 1 17.9 15.88 1.47 -895 1 13.47 5.84 28.76 -896 1 8.96 22.14 21.0 -897 1 12.96 24.15 0.94 -898 1 26.13 23.25 8.89 -899 1 6.01 28.65 6.08 -900 1 22.88 20.21 6.1 -901 1 30.34 20.77 10.49 -902 1 12.19 28.16 10.6 -903 1 5.8 5.33 30.84 -904 1 29.83 26.29 15.91 -905 1 18.28 0.14 5.58 -906 1 1.91 17.34 5.88 -907 1 24.05 18.42 22.53 -908 1 10.82 21.55 3.57 -909 1 11.29 26.73 5.6 -910 1 21.34 14.41 3.22 -911 1 12.61 18.99 24.17 -912 1 25.02 18.6 25.9 -913 1 29.0 21.05 13.14 -914 1 17.72 27.28 30.27 -915 1 30.56 24.81 23.12 -916 1 17.09 20.05 24.02 -917 1 7.35 6.83 21.31 -918 1 3.39 22.32 21.05 -919 1 2.28 29.8 30.23 -920 1 5.29 25.66 14.8 -921 1 26.16 30.72 21.04 -922 1 21.63 6.32 11.68 -923 1 15.45 18.06 4.65 -924 1 5.76 28.33 24.04 -925 1 15.08 29.21 16.09 -926 1 18.76 6.14 6.94 -927 1 22.31 30.25 26.46 -928 1 18.49 22.04 30.93 -929 1 11.15 16.42 9.89 -930 1 4.34 7.98 30.25 -931 1 9.29 29.92 8.58 -932 1 22.97 27.09 8.04 -933 1 20.71 16.7 15.75 -934 1 30.36 7.49 5.24 -935 1 29.56 19.54 0.83 -936 1 30.71 14.04 20.91 -937 1 19.36 4.06 27.14 -938 1 23.41 10.8 2.14 -939 1 1.51 1.32 0.44 -940 1 8.16 14.39 1.63 -941 1 20.66 6.74 4.62 -942 1 20.78 26.26 3.85 -943 1 5.11 15.12 21.64 -944 1 12.53 20.03 17.67 -945 1 28.63 18.4 12.56 -946 1 1.95 21.69 8.08 -947 1 21.53 0.93 7.84 -948 1 2.69 22.51 17.17 -949 1 19.29 22.12 6.05 -950 1 23.68 2.14 11.01 -951 1 27.14 17.8 3.72 -952 1 2.22 14.81 3.31 -953 1 23.1 6.43 14.62 -954 1 0.22 12.59 3.57 -955 1 13.21 22.86 3.67 -956 1 13.45 2.1 20.14 -957 1 12.52 17.12 0.46 -958 1 3.07 27.45 9.03 -959 1 15.33 10.95 11.78 -960 1 0.05 4.26 9.75 -961 1 23.05 16.98 24.69 -962 1 16.15 16.28 6.51 -963 1 30.05 28.87 9.61 -964 1 6.67 29.5 16.95 -965 1 21.95 14.44 14.94 -966 1 22.58 22.47 30.33 -967 1 21.34 19.29 9.9 -968 1 29.31 21.79 20.79 -969 1 5.55 2.56 30.23 -970 1 25.88 3.17 22.22 -971 1 22.38 18.32 30.08 -972 1 6.27 19.24 8.86 -973 1 0.34 24.29 1.49 -974 1 20.49 24.13 0.25 -975 1 2.94 1.41 2.74 -976 1 24.88 25.38 7.35 -977 1 28.18 14.89 14.6 -978 1 7.84 30.36 4.39 -979 1 14.54 9.59 14.4 -980 1 27.63 12.3 15.83 -981 1 11.15 14.17 27.97 -982 1 25.27 20.88 8.35 -983 1 17.06 14.76 27.78 -984 1 3.9 14.79 15.06 -985 1 13.81 3.82 17.03 -986 1 28.55 24.1 26.15 -987 1 29.28 21.79 15.76 -988 1 15.05 30.12 27.83 -989 1 15.42 3.77 6.76 -990 1 22.65 12.12 11.24 -991 1 11.29 4.96 2.18 -992 1 2.15 7.43 7.57 -993 1 30.21 10.13 26.21 -994 1 24.42 22.18 4.42 -995 1 8.68 14.72 22.08 -996 1 23.1 6.9 27.1 -997 1 18.71 27.2 21.72 -998 1 14.12 12.7 30.76 -999 1 18.81 6.5 10.98 -1000 1 26.66 15.4 4.83 diff --git a/examples/PACKAGES/pair_sw_angle_table/spce.in b/examples/PACKAGES/pair_sw_angle_table/spce.in deleted file mode 100644 index 8b1ef719a6..0000000000 --- a/examples/PACKAGES/pair_sw_angle_table/spce.in +++ /dev/null @@ -1,45 +0,0 @@ -log none - -#SPC/E water - -units real -atom_style atomic - -read_data spce.data - -#hybrid pair style consisting of -#pair_style table to read in CG pair potential -#pair_style sw/angle/table for sw interactions with tabulated angular potential -pair_style hybrid/overlay table linear 1200 sw/angle/table - -#pair coefficients -pair_coeff 1 1 table table_CG_CG.txt VOTCA -pair_coeff * * sw/angle/table spce.sw type - -#nvt run with nose-hoover thermostat -#time coupling of 100 ts for thermostat -#target T is 300 K -fix 1 all nvt temp 300.0 300.0 200.0 - -#create initial velocities -velocity all create 300 432567 dist uniform -#remove center of mass linear momentum -velocity all zero linear - -#remove center of mass linear momentum every 1000 time steps in each cartesian direction -fix remove all momentum 1000 linear 1 1 1 - -#timestep of 2 fs -timestep 2.0 - -#print out thermodynamic info every 100 ts -thermo 100 - -#run 10000 ts -run 10000 - -#write out dump file every 10 ts for 100000 ts -dump 2 all custom 10 spce.dump id type x y z fx fy fz -run 100000 - -undump 2 diff --git a/examples/PACKAGES/pair_sw_angle_table/table_CG_CG.txt b/examples/PACKAGES/pair_sw_angle_table/table_CG_CG.txt deleted file mode 100644 index f4ccdd4b4e..0000000000 --- a/examples/PACKAGES/pair_sw_angle_table/table_CG_CG.txt +++ /dev/null @@ -1,1203 +0,0 @@ -VOTCA -N 1200 R 0.010000 12.000000 - -1 1.0000000000e-02 1.5390100510e+15 2.1517330910e+16 -2 2.0000000000e-02 1.3370836560e+15 1.8774943350e+16 -3 3.0000000000e-02 1.1616510900e+15 1.6231560530e+16 -4 4.0000000000e-02 1.0092362200e+15 1.4101892510e+16 -5 5.0000000000e-02 8.7681900090e+14 1.2251648380e+16 -6 6.0000000000e-02 7.6177563290e+14 1.0644166230e+16 -7 7.0000000000e-02 6.6182657340e+14 9.2475943770e+15 -8 8.0000000000e-02 5.7499136800e+14 8.0342602660e+15 -9 9.0000000000e-02 4.9954940840e+14 6.9801221150e+15 -10 1.0000000000e-01 4.3400583970e+14 6.0642925570e+15 -11 1.1000000000e-01 3.7706193970e+14 5.2686247630e+15 -12 1.2000000000e-01 3.2758938550e+14 4.5773528620e+15 -13 1.3000000000e-01 2.8460789650e+14 3.9767795520e+15 -14 1.4000000000e-01 2.4726581000e+14 3.4550046890e+15 -15 1.5000000000e-01 2.1482320610e+14 3.0016894950e+15 -16 1.6000000000e-01 1.8663724620e+14 2.6078516910e+15 -17 1.7000000000e-01 1.6214943590e+14 2.2656875260e+15 -18 1.8000000000e-01 1.4087455790e+14 1.9684171380e+15 -19 1.9000000000e-01 1.2239105840e+14 1.7101502250e+15 -20 2.0000000000e-01 1.0633269330e+14 1.4857693190e+15 -21 2.1000000000e-01 9.2381272170e+13 1.2908283940e+15 -22 2.2000000000e-01 8.0260352480e+13 1.1214647680e+15 -23 2.3000000000e-01 6.9729762630e+13 9.7432255940e+14 -24 2.4000000000e-01 6.0580842800e+13 8.4648620020e+14 -25 2.5000000000e-01 5.2632310450e+13 7.3542265870e+14 -26 2.6000000000e-01 4.5726668290e+13 6.3893125110e+14 -27 2.7000000000e-01 3.9727083510e+13 5.5510003510e+14 -28 2.8000000000e-01 3.4514676520e+13 4.8226792540e+14 -29 2.9000000000e-01 2.9986165360e+13 4.1899178020e+14 -30 3.0000000000e-01 2.6051819210e+13 3.6401780550e+14 -31 3.1000000000e-01 2.2633680440e+13 3.1625671190e+14 -32 3.2000000000e-01 1.9664019850e+13 2.7476213060e+14 -33 3.3000000000e-01 1.7083994700e+13 2.3871186160e+14 -34 3.4000000000e-01 1.4842482730e+13 2.0739158160e+14 -35 3.5000000000e-01 1.2895069180e+13 1.8018069090e+14 -36 3.6000000000e-01 1.1203166760e+13 1.5654001530e+14 -37 3.7000000000e-01 9.7332510350e+12 1.3600112350e+14 -38 3.8000000000e-01 8.4561961580e+12 1.1815704470e+14 -39 3.9000000000e-01 7.3466977490e+12 1.0265420510e+14 -40 4.0000000000e-01 6.3827714970e+12 8.9185421350e+13 -41 4.1000000000e-01 5.5453175530e+12 7.7483814470e+13 -42 4.2000000000e-01 4.8177420700e+12 6.7317521340e+13 -43 4.3000000000e-01 4.1856284030e+12 5.8485100540e+13 -44 4.4000000000e-01 3.6364514480e+12 5.0811540850e+13 -45 4.5000000000e-01 3.1593294630e+12 4.4144793450e+13 -46 4.6000000000e-01 2.7448084480e+12 3.8352759160e+13 -47 4.7000000000e-01 2.3846748190e+12 3.3320670910e+13 -48 4.8000000000e-01 2.0717926600e+12 2.8948819710e+13 -49 4.9000000000e-01 1.7999623210e+12 2.5150578890e+13 -50 5.0000000000e-01 1.5637975860e+12 2.1850687690e+13 -51 5.1000000000e-01 1.3586189330e+12 1.8983759960e+13 -52 5.2000000000e-01 1.1803608230e+12 1.6492988570e+13 -53 5.3000000000e-01 1.0254911360e+12 1.4329019780e+13 -54 5.4000000000e-01 8.9094118400e+11 1.2448975330e+13 -55 5.5000000000e-01 7.7404490960e+11 1.0815602820e+13 -56 5.6000000000e-01 6.7248605500e+11 9.3965375690e+12 -57 5.7000000000e-01 5.8425226830e+11 8.1636613100e+12 -58 5.8000000000e-01 5.0759522880e+11 7.0925450460e+12 -59 5.9000000000e-01 4.4099600520e+11 6.1619649960e+12 -60 6.0000000000e-01 3.8313495790e+11 5.3534820520e+12 -61 6.1000000000e-01 3.3286559110e+11 4.6510764180e+12 -62 6.2000000000e-01 2.8919183550e+11 4.0408301810e+12 -63 6.3000000000e-01 2.5124831160e+11 3.5106515320e+12 -64 6.4000000000e-01 2.1828318200e+11 3.0500351720e+12 -65 6.5000000000e-01 1.8964325470e+11 2.6498541560e+12 -66 6.6000000000e-01 1.6476103990e+11 2.3021790410e+12 -67 6.7000000000e-01 1.4314350540e+11 2.0001207710e+12 -68 6.8000000000e-01 1.2436230780e+11 1.7376941700e+12 -69 6.9000000000e-01 1.0804530420e+11 1.5096993500e+12 -70 7.0000000000e-01 9.3869179290e+10 1.3116186770e+12 -71 7.1000000000e-01 8.1553038190e+10 1.1395272530e+12 -72 7.2000000000e-01 7.0852841020e+10 9.9001514990e+11 -73 7.3000000000e-01 6.1556567270e+10 8.6011983840e+11 -74 7.4000000000e-01 5.3480014620e+10 7.4726749030e+11 -75 7.5000000000e-01 4.6463149110e+10 6.4922197710e+11 -76 7.6000000000e-01 4.0366934090e+10 5.6404056250e+11 -77 7.7000000000e-01 3.5070575270e+10 4.9003540760e+11 -78 7.8000000000e-01 3.0469127200e+10 4.2574012690e+11 -79 7.9000000000e-01 2.6471413860e+10 3.6988073290e+11 -80 8.0000000000e-01 2.2998222010e+10 3.2135039170e+11 -81 8.1000000000e-01 1.9980731610e+10 2.7918749220e+11 -82 8.2000000000e-01 1.7359152180e+10 2.4255659190e+11 -83 8.3000000000e-01 1.5081538060e+10 2.1073186270e+11 -84 8.4000000000e-01 1.3102759170e+10 1.8308270910e+11 -85 8.5000000000e-01 1.1383606700e+10 1.5906127310e+11 -86 8.6000000000e-01 9.8900162880e+09 1.3819157870e+11 -87 8.7000000000e-01 8.5923929670e+09 1.2006010050e+11 -88 8.8000000000e-01 7.4650248040e+09 1.0430756970e+11 -89 8.9000000000e-01 6.4855734070e+09 9.0621855610e+10 -90 9.0000000000e-01 5.6346312990e+09 7.8731780830e+10 -91 9.1000000000e-01 4.8953373730e+09 6.8401747800e+10 -92 9.2000000000e-01 4.2530427840e+09 5.9427070660e+10 -93 9.3000000000e-01 3.6950207000e+09 5.1629919420e+10 -94 9.4000000000e-01 3.2102141140e+09 4.4855796350e+10 -95 9.5000000000e-01 2.7890167600e+09 3.8970474660e+10 -96 9.6000000000e-01 2.4230827630e+09 3.3857338820e+10 -97 9.7000000000e-01 2.1051612740e+09 2.9415073900e+10 -98 9.8000000000e-01 1.8289527940e+09 2.5555658020e+10 -99 9.9000000000e-01 1.5889843520e+09 2.2202618260e+10 -100 1.0000000000e+00 1.3805010610e+09 1.9289515350e+10 -101 1.0100000000e+00 1.1993718980e+09 1.6758627210e+10 -102 1.0200000000e+00 1.0420078550e+09 1.4559805200e+10 -103 1.0300000000e+00 9.0529082110e+08 1.2649480460e+10 -104 1.0400000000e+00 7.8651179720e+08 1.0989800600e+10 -105 1.0500000000e+00 6.8331721990e+08 9.5478796640e+09 -106 1.0600000000e+00 5.9366232610e+08 8.2951465080e+09 -107 1.0700000000e+00 5.1577063650e+08 7.2067786790e+09 -108 1.0800000000e+00 4.4809875540e+08 6.2612105610e+09 -109 1.0900000000e+00 3.8930578900e+08 5.4397060660e+09 -110 1.1000000000e+00 3.3822677600e+08 4.7259873780e+09 -111 1.1100000000e+00 2.9384960420e+08 4.1059124200e+09 -112 1.1200000000e+00 2.5529495590e+08 3.5671946310e+09 -113 1.1300000000e+00 2.2179888490e+08 3.0991595130e+09 -114 1.1400000000e+00 1.9269767840e+08 2.6925331190e+09 -115 1.1500000000e+00 1.6741470680e+08 2.3392582940e+09 -116 1.1600000000e+00 1.4544899700e+08 2.0323350270e+09 -117 1.1700000000e+00 1.2636530640e+08 1.7656817420e+09 -118 1.1800000000e+00 1.0978549870e+08 1.5340148030e+09 -119 1.1900000000e+00 9.5381050880e+07 1.3327438110e+09 -120 1.2000000000e+00 8.2866544090e+07 1.1578806560e+09 -121 1.2100000000e+00 7.1994007890e+07 1.0059604880e+09 -122 1.2200000000e+00 6.2548006910e+07 8.7397306220e+08 -123 1.2300000000e+00 5.4341372050e+07 7.5930309660e+08 -124 1.2400000000e+00 4.7211491810e+07 6.5967844720e+08 -125 1.2500000000e+00 4.1017090210e+07 5.7312508750e+08 -126 1.2600000000e+00 3.5635427400e+07 4.9792799400e+08 -127 1.2700000000e+00 3.0959867700e+07 4.3259716360e+08 -128 1.2800000000e+00 2.6897766570e+07 3.7583808940e+08 -129 1.2900000000e+00 2.3368634950e+07 3.2652611100e+08 -130 1.3000000000e+00 2.0302544380e+07 2.8368412930e+08 -131 1.3100000000e+00 1.7638741380e+07 2.4646324610e+08 -132 1.3200000000e+00 1.5324443660e+07 2.1412594280e+08 -133 1.3300000000e+00 1.3313794240e+07 1.8603146760e+08 -134 1.3400000000e+00 1.1566952840e+07 1.6162313870e+08 -135 1.3500000000e+00 1.0049306430e+07 1.4041731380e+08 -136 1.3600000000e+00 8.7307833840e+06 1.2199380710e+08 -137 1.3700000000e+00 7.5852576540e+06 1.0598756360e+08 -138 1.3800000000e+00 6.5900310600e+06 9.2081425300e+07 -139 1.3900000000e+00 5.7253835470e+06 7.9999847130e+07 -140 1.4000000000e+00 4.9741824370e+06 6.9503436980e+07 -141 1.4100000000e+00 4.3215429520e+06 6.0384212290e+07 -142 1.4200000000e+00 3.7545332780e+06 5.2461478920e+07 -143 1.4300000000e+00 3.2619183220e+06 4.5578250780e+07 -144 1.4400000000e+00 2.8339370970e+06 3.9598139180e+07 -145 1.4500000000e+00 2.4621093100e+06 3.4402650380e+07 -146 1.4600000000e+00 2.1390673290e+06 2.9888837650e+07 -147 1.4700000000e+00 1.8584101920e+06 2.5967261420e+07 -148 1.4800000000e+00 1.6145767810e+06 2.2560217080e+07 -149 1.4900000000e+00 1.4027356250e+06 1.9600195280e+07 -150 1.5000000000e+00 1.2186891680e+06 1.7028544260e+07 -151 1.5100000000e+00 1.0587905960e+06 1.4794307680e+07 -152 1.5200000000e+00 9.1987157580e+05 1.2853214960e+07 -153 1.5300000000e+00 7.9917947840e+05 1.1166804040e+07 -154 1.5400000000e+00 6.9432283320e+05 9.7016592970e+06 -155 1.5500000000e+00 6.0322394380e+05 8.4287494270e+06 -156 1.5600000000e+00 5.2407771850e+05 7.3228521760e+06 -157 1.5700000000e+00 4.5531590360e+05 6.3620545920e+06 -158 1.5800000000e+00 3.9557600860e+05 5.5273188170e+06 -159 1.5900000000e+00 3.4367430900e+05 4.8021048650e+06 -160 1.6000000000e+00 2.9858239160e+05 4.1720428830e+06 -161 1.6100000000e+00 2.5940677620e+05 3.6246484220e+06 -162 1.6200000000e+00 2.2537121220e+05 3.1490750570e+06 -163 1.6300000000e+00 1.9580129720e+05 2.7358994750e+06 -164 1.6400000000e+00 1.7011111410e+05 2.3769347520e+06 -165 1.6500000000e+00 1.4779162110e+05 2.0650681300e+06 -166 1.6600000000e+00 1.2840056570e+05 1.7941200870e+06 -167 1.6700000000e+00 1.1155372100e+05 1.5587218830e+06 -168 1.6800000000e+00 9.6917272910e+04 1.3542091900e+06 -169 1.6900000000e+00 8.4201205530e+04 1.1765296620e+06 -170 1.7000000000e+00 7.3153554570e+04 1.0221626440e+06 -171 1.7100000000e+00 6.3555414830e+04 8.8804940820e+05 -172 1.7200000000e+00 5.5216602630e+04 7.7153255030e+05 -173 1.7300000000e+00 4.7971887440e+04 6.7030333080e+05 -174 1.7400000000e+00 4.1677717830e+04 5.8235592920e+05 -175 1.7500000000e+00 3.6209377130e+04 5.0594769970e+05 -176 1.7600000000e+00 3.1458512140e+04 4.3956464070e+05 -177 1.7700000000e+00 2.7330986170e+04 3.8189139610e+05 -178 1.7800000000e+00 2.3745013820e+04 3.3178519130e+05 -179 1.7900000000e+00 2.0629540310e+04 2.8825319000e+05 -180 1.8000000000e+00 1.7922833690e+04 2.5043282140e+05 -181 1.8100000000e+00 1.5571261530e+04 2.1757468850e+05 -182 1.8200000000e+00 1.3528228280e+04 1.8902771940e+05 -183 1.8300000000e+00 1.1753251980e+04 1.6422626610e+05 -184 1.8400000000e+00 1.0211162120e+04 1.4267889680e+05 -185 1.8500000000e+00 8.8714027380e+03 1.2395865830e+05 -186 1.8600000000e+00 7.7074269920e+03 1.0769461580e+05 -187 1.8700000000e+00 6.6961711240e+03 9.3564503040e+04 -188 1.8800000000e+00 5.8175974640e+03 8.1288337100e+04 -189 1.8900000000e+00 5.0542973920e+03 7.0622870140e+04 -190 1.9000000000e+00 4.3911463950e+03 6.1356769800e+04 -191 1.9100000000e+00 3.8150043740e+03 5.3306431660e+04 -192 1.9200000000e+00 3.3144552850e+03 4.6312341170e+04 -193 1.9300000000e+00 2.8795809280e+03 4.0235912960e+04 -194 1.9400000000e+00 2.5017644250e+03 3.4956744810e+04 -195 1.9500000000e+00 2.1735194790e+03 3.0370231910e+04 -196 1.9600000000e+00 1.8883420360e+03 2.6385494170e+04 -197 1.9700000000e+00 1.6405814060e+03 2.2923575440e+04 -198 1.9800000000e+00 1.4253283030e+03 1.9915879070e+04 -199 1.9900000000e+00 1.2383175650e+03 1.7302808640e+04 -200 2.0000000000e+00 1.0758436410e+03 1.5032587100e+04 -201 2.0100000000e+00 9.3468717030e+02 1.3060230840e+04 -202 2.0200000000e+00 8.1205118730e+02 1.1346658320e+04 -203 2.0300000000e+00 7.0550570470e+02 9.8579157300e+03 -204 2.0400000000e+00 6.1293956240e+02 8.5645041750e+03 -205 2.0500000000e+00 5.3251859570e+02 7.4407951710e+03 -206 2.0600000000e+00 4.6264929230e+02 6.4645228320e+03 -207 2.0700000000e+00 4.0194721720e+02 5.6163426730e+03 -208 2.0800000000e+00 3.4920958090e+02 4.8794483120e+03 -209 2.0900000000e+00 3.0339140600e+02 4.2392384540e+03 -210 2.1000000000e+00 2.6358482200e+02 3.6830275730e+03 -211 2.1100000000e+00 2.2900107590e+02 3.1997945490e+03 -212 2.1200000000e+00 1.9895490330e+02 2.7799642980e+03 -213 2.1300000000e+00 1.7285095010e+02 2.4152180320e+03 -214 2.1400000000e+00 1.5017197590e+02 2.0983284390e+03 -215 2.1500000000e+00 1.3046860510e+02 1.8230164640e+03 -216 2.1600000000e+00 1.1335042260e+02 1.5838269000e+03 -217 2.1700000000e+00 9.8478237570e+01 1.3760202940e+03 -218 2.1800000000e+00 8.5557363230e+01 1.1954790320e+03 -219 2.1900000000e+00 7.4331777090e+01 1.0386257540e+03 -220 2.2000000000e+00 6.4579048210e+01 9.0235246990e+02 -221 2.2100000000e+00 5.6105929810e+01 7.8395897350e+02 -222 2.2200000000e+00 4.8744530110e+01 6.8109934040e+02 -223 2.2300000000e+00 4.2348985630e+01 5.9173544430e+02 -224 2.2400000000e+00 3.6792570990e+01 5.1409657190e+02 -225 2.2500000000e+00 3.1965187820e+01 4.4664433710e+02 -226 2.2600000000e+00 2.7771183280e+01 3.8804219830e+02 -227 2.2700000000e+00 2.4127454700e+01 3.3712897510e+02 -228 2.2800000000e+00 2.0961802900e+01 2.9289584070e+02 -229 2.2900000000e+00 1.8211501630e+01 2.5446633130e+02 -230 2.3000000000e+00 1.5822054690e+01 2.2107898030e+02 -231 2.3100000000e+00 1.3746116030e+01 1.9207222920e+02 -232 2.3200000000e+00 1.1942551680e+01 1.6687131990e+02 -233 2.3300000000e+00 1.0375624680e+01 1.4497690530e+02 -234 2.3400000000e+00 9.0142869290e+00 1.2595515570e+02 -235 2.3500000000e+00 7.8315640090e+00 1.0942916200e+02 -236 2.3600000000e+00 6.8040206970e+00 9.5071467470e+01 -237 2.3700000000e+00 5.9112965930e+00 8.2597579690e+01 -238 2.3800000000e+00 5.1357026910e+00 7.1760333060e+01 -239 2.3900000000e+00 4.4618708810e+00 6.2344991470e+01 -240 2.4000000000e+00 3.8764494280e+00 5.3036352210e+01 -241 2.4100000000e+00 3.3678384170e+00 4.8261295350e+01 -242 2.4200000000e+00 2.8941569300e+00 4.5857614440e+01 -243 2.4300000000e+00 2.4468631800e+00 4.3406963180e+01 -244 2.4400000000e+00 2.0256587860e+00 4.0812932280e+01 -245 2.4500000000e+00 1.6301260100e+00 3.8266641770e+01 -246 2.4600000000e+00 1.2597277660e+00 3.5780026500e+01 -247 2.4700000000e+00 9.1380761130e-01 3.3365021740e+01 -248 2.4800000000e+00 5.9158975140e-01 3.1033562180e+01 -249 2.4900000000e+00 2.9217903890e-01 2.8797954450e+01 -250 2.5000000000e+00 1.4560973470e-02 2.6671263930e+01 -251 2.5100000000e+00 -2.4238415820e-01 2.4661823870e+01 -252 2.5200000000e+00 -4.7981058030e-01 2.2768039630e+01 -253 2.5300000000e+00 -6.9883632600e-01 2.0983874620e+01 -254 2.5400000000e+00 -9.0052909770e-01 1.9303963110e+01 -255 2.5500000000e+00 -1.0859062660e+00 1.7723272100e+01 -256 2.5600000000e+00 -1.2559348720e+00 1.6236768280e+01 -257 2.5700000000e+00 -1.4115316230e+00 1.4839418560e+01 -258 2.5800000000e+00 -1.5535628980e+00 1.3526189880e+01 -259 2.5900000000e+00 -1.6828447430e+00 1.2292001960e+01 -260 2.6000000000e+00 -1.8001428730e+00 1.1131681390e+01 -261 2.6100000000e+00 -1.9061744430e+00 1.0040648660e+01 -262 2.6200000000e+00 -2.0016168960e+00 9.0155628370e+00 -263 2.6300000000e+00 -2.0871168150e+00 8.0536395060e+00 -264 2.6400000000e+00 -2.1632916940e+00 7.1520107860e+00 -265 2.6500000000e+00 -2.2307299330e+00 6.3077675390e+00 -266 2.6600000000e+00 -2.2899908440e+00 5.5180009250e+00 -267 2.6700000000e+00 -2.3416046480e+00 4.7798017190e+00 -268 2.6800000000e+00 -2.3860724750e+00 4.0902608440e+00 -269 2.6900000000e+00 -2.4238663650e+00 3.4464440960e+00 -270 2.7000000000e+00 -2.4554292680e+00 2.8453664940e+00 -271 2.7100000000e+00 -2.4811759890e+00 2.2843626470e+00 -272 2.7200000000e+00 -2.5014979300e+00 1.7614298710e+00 -273 2.7300000000e+00 -2.5167678200e+00 1.2748621430e+00 -274 2.7400000000e+00 -2.5273406710e+00 8.2290948110e-01 -275 2.7500000000e+00 -2.5335537710e+00 4.0379949770e-01 -276 2.7600000000e+00 -2.5357266870e+00 1.5760010280e-02 -277 2.7700000000e+00 -2.5341612640e+00 -3.4298090310e-01 -278 2.7800000000e+00 -2.5291416280e+00 -6.7419561340e-01 -279 2.7900000000e+00 -2.5209341800e+00 -9.7967404420e-01 -280 2.8000000000e+00 -2.5097876030e+00 -1.2612416950e+00 -281 2.8100000000e+00 -2.4959335160e+00 -1.5205003860e+00 -282 2.8200000000e+00 -2.4795897790e+00 -1.7585895080e+00 -283 2.8300000000e+00 -2.4609637910e+00 -1.9764437290e+00 -284 2.8400000000e+00 -2.4402531510e+00 -2.1750280650e+00 -285 2.8500000000e+00 -2.4176456570e+00 -2.3553224700e+00 -286 2.8600000000e+00 -2.3933193080e+00 -2.5183069580e+00 -287 2.8700000000e+00 -2.3674423020e+00 -2.6649614780e+00 -288 2.8800000000e+00 -2.3401730380e+00 -2.7962661310e+00 -289 2.8900000000e+00 -2.3116601130e+00 -2.9132049510e+00 -290 2.9000000000e+00 -2.2820423250e+00 -3.0167697150e+00 -291 2.9100000000e+00 -2.2514488140e+00 -3.1079034930e+00 -292 2.9200000000e+00 -2.2199997690e+00 -3.1874493890e+00 -293 2.9300000000e+00 -2.1878071410e+00 -3.2562082020e+00 -294 2.9400000000e+00 -2.1549747780e+00 -3.3149866360e+00 -295 2.9500000000e+00 -2.1215984330e+00 -3.3645944150e+00 -296 2.9600000000e+00 -2.0877657580e+00 -3.4058413510e+00 -297 2.9700000000e+00 -2.0535563080e+00 -3.4395371300e+00 -298 2.9800000000e+00 -2.0190415380e+00 -3.4664917760e+00 -299 2.9900000000e+00 -1.9842848030e+00 -3.4875215040e+00 -300 3.0000000000e+00 -1.9493413610e+00 -3.5034563820e+00 -301 3.0100000000e+00 -1.9142585830e+00 -3.5150471190e+00 -302 3.0200000000e+00 -1.8790770150e+00 -3.5228910160e+00 -303 3.0300000000e+00 -1.8438314390e+00 -3.5275214590e+00 -304 3.0400000000e+00 -1.8085510860e+00 -3.5289583340e+00 -305 3.0500000000e+00 -1.7732596360e+00 -3.5288908310e+00 -306 3.0600000000e+00 -1.7379752190e+00 -3.5280320940e+00 -307 3.0700000000e+00 -1.7027104110e+00 -3.5253862790e+00 -308 3.0800000000e+00 -1.6674722390e+00 -3.5223395310e+00 -309 3.0900000000e+00 -1.6322621780e+00 -3.5194378970e+00 -310 3.1000000000e+00 -1.5970761530e+00 -3.5173081740e+00 -311 3.1100000000e+00 -1.5619051030e+00 -3.5168447480e+00 -312 3.1200000000e+00 -1.5267378260e+00 -3.5168563320e+00 -313 3.1300000000e+00 -1.4915638140e+00 -3.5177518380e+00 -314 3.1400000000e+00 -1.4563738200e+00 -3.5198200760e+00 -315 3.1500000000e+00 -1.4211598630e+00 -3.5226190880e+00 -316 3.1600000000e+00 -1.3859152220e+00 -3.5260255420e+00 -317 3.1700000000e+00 -1.3506344420e+00 -3.5299136690e+00 -318 3.1800000000e+00 -1.3153133290e+00 -3.5341578930e+00 -319 3.1900000000e+00 -1.2799489510e+00 -3.5386343920e+00 -320 3.2000000000e+00 -1.2445396420e+00 -3.5432253600e+00 -321 3.2100000000e+00 -1.2090851000e+00 -3.5477800910e+00 -322 3.2200000000e+00 -1.1735869120e+00 -3.5520723480e+00 -323 3.2300000000e+00 -1.1380490760e+00 -3.5558443110e+00 -324 3.2400000000e+00 -1.1024780970e+00 -3.5588459720e+00 -325 3.2500000000e+00 -1.0668829990e+00 -3.5606965620e+00 -326 3.2600000000e+00 -1.0312753150e+00 -3.5607083610e+00 -327 3.2700000000e+00 -9.9566909100e-01 -3.5605541570e+00 -328 3.2800000000e+00 -9.6008088680e-01 -3.5579489480e+00 -329 3.2900000000e+00 -9.2452977440e-01 -3.5533045150e+00 -330 3.3000000000e+00 -8.8903733850e-01 -3.5464131370e+00 -331 3.3100000000e+00 -8.5362827280e-01 -3.5368973480e+00 -332 3.3200000000e+00 -8.1833336060e-01 -3.5239572210e+00 -333 3.3300000000e+00 -7.8319245590e-01 -3.5065687200e+00 -334 3.3400000000e+00 -7.4825507930e-01 -3.4837450990e+00 -335 3.3500000000e+00 -7.1358041810e-01 -3.4545190770e+00 -336 3.3600000000e+00 -6.7923732650e-01 -3.4179238010e+00 -337 3.3700000000e+00 -6.4530432520e-01 -3.3729926040e+00 -338 3.3800000000e+00 -6.1186960170e-01 -3.3187588290e+00 -339 3.3900000000e+00 -5.7903101040e-01 -3.2542297980e+00 -340 3.4000000000e+00 -5.4689607220e-01 -3.1783580730e+00 -341 3.4100000000e+00 -5.1558072820e-01 -3.0904661310e+00 -342 3.4200000000e+00 -4.8520310790e-01 -2.9907576290e+00 -343 3.4300000000e+00 -4.5587729660e-01 -2.8798705460e+00 -344 3.4400000000e+00 -4.2771208900e-01 -2.7583688810e+00 -345 3.4500000000e+00 -4.0081098950e-01 -2.6267815840e+00 -346 3.4600000000e+00 -3.7527221170e-01 -2.4856376550e+00 -347 3.4700000000e+00 -3.5118867890e-01 -2.3354660560e+00 -348 3.4800000000e+00 -3.2864802400e-01 -2.1767958410e+00 -349 3.4900000000e+00 -3.0773258900e-01 -2.0101012320e+00 -350 3.5000000000e+00 -2.8851942590e-01 -1.8357436110e+00 -351 3.5100000000e+00 -2.7107800890e-01 -1.6548080920e+00 -352 3.5200000000e+00 -2.5545880110e-01 -1.4699936560e+00 -353 3.5300000000e+00 -2.4168181970e-01 -1.2847553720e+00 -354 3.5400000000e+00 -2.2973434990e-01 -1.1024244830e+00 -355 3.5500000000e+00 -2.1957094400e-01 -9.2627328940e-01 -356 3.5600000000e+00 -2.1111342220e-01 -7.5957368970e-01 -357 3.5700000000e+00 -2.0425087220e-01 -6.0559684560e-01 -358 3.5800000000e+00 -1.9883964940e-01 -4.6761229440e-01 -359 3.5900000000e+00 -1.9470337660e-01 -3.4905079620e-01 -360 3.6000000000e+00 -1.9163294430e-01 -2.5373424880e-01 -361 3.6100000000e+00 -1.8939187810e-01 -1.8353921730e-01 -362 3.6200000000e+00 -1.8774317600e-01 -1.3643213030e-01 -363 3.6300000000e+00 -1.8647614590e-01 -1.0900277830e-01 -364 3.6400000000e+00 -1.8541177300e-01 -1.0217451770e-01 -365 3.6500000000e+00 -1.8440272000e-01 -1.0257729120e-01 -366 3.6600000000e+00 -1.8333332690e-01 -1.1032823210e-01 -367 3.6700000000e+00 -1.8211961100e-01 -1.2921992570e-01 -368 3.6800000000e+00 -1.8070926700e-01 -1.5163890710e-01 -369 3.6900000000e+00 -1.7908166700e-01 -1.7442524050e-01 -370 3.7000000000e+00 -1.7724786040e-01 -1.9407009560e-01 -371 3.7100000000e+00 -1.7524726610e-01 -2.0823224750e-01 -372 3.7200000000e+00 -1.7313113340e-01 -2.1707301960e-01 -373 3.7300000000e+00 -1.7094600210e-01 -2.2155931460e-01 -374 3.7400000000e+00 -1.6873039540e-01 -2.2155890460e-01 -375 3.7500000000e+00 -1.6651481940e-01 -2.2155573260e-01 -376 3.7600000000e+00 -1.6432176310e-01 -2.1804279820e-01 -377 3.7700000000e+00 -1.6216569890e-01 -2.1356882610e-01 -378 3.7800000000e+00 -1.6005308190e-01 -2.0885944940e-01 -379 3.7900000000e+00 -1.5798235030e-01 -2.0472213750e-01 -380 3.8000000000e+00 -1.5594392560e-01 -2.0241705720e-01 -381 3.8100000000e+00 -1.5392117290e-01 -2.0241827750e-01 -382 3.8200000000e+00 -1.5189520660e-01 -2.0277318370e-01 -383 3.8300000000e+00 -1.4984969490e-01 -2.0558456320e-01 -384 3.8400000000e+00 -1.4777182060e-01 -2.0947681570e-01 -385 3.8500000000e+00 -1.4565228170e-01 -2.1411724290e-01 -386 3.8600000000e+00 -1.4348529090e-01 -2.1915859900e-01 -387 3.8700000000e+00 -1.4126857580e-01 -2.2425124170e-01 -388 3.8800000000e+00 -1.3900337870e-01 -2.2904532330e-01 -389 3.8900000000e+00 -1.3669445690e-01 -2.3317711800e-01 -390 3.9000000000e+00 -1.3435008260e-01 -2.3624008380e-01 -391 3.9100000000e+00 -1.3198159090e-01 -2.3798596650e-01 -392 3.9200000000e+00 -1.2960112040e-01 -2.3812682950e-01 -393 3.9300000000e+00 -1.2721935400e-01 -2.3811467960e-01 -394 3.9400000000e+00 -1.2484506660e-01 -2.3702815340e-01 -395 3.9500000000e+00 -1.2248512560e-01 -2.3523949930e-01 -396 3.9600000000e+00 -1.2014449050e-01 -2.3305519030e-01 -397 3.9700000000e+00 -1.1782621320e-01 -2.3066255720e-01 -398 3.9800000000e+00 -1.1553143760e-01 -2.2825101140e-01 -399 3.9900000000e+00 -1.1325940020e-01 -2.2601755080e-01 -400 4.0000000000e+00 -1.1100742940e-01 -2.2417862310e-01 -401 4.0100000000e+00 -1.0877118630e-01 -2.2286349760e-01 -402 4.0200000000e+00 -1.0654586480e-01 -2.2202230410e-01 -403 4.0300000000e+00 -1.0432739300e-01 -2.2154405680e-01 -404 4.0400000000e+00 -1.0211267260e-01 -2.2132766590e-01 -405 4.0500000000e+00 -9.9899579570e-02 -2.2126903570e-01 -406 4.0600000000e+00 -9.7686963680e-02 -2.2125247670e-01 -407 4.0700000000e+00 -9.5474648740e-02 -2.2122106790e-01 -408 4.0800000000e+00 -9.3263432500e-02 -2.2107465710e-01 -409 4.0900000000e+00 -9.1055086710e-02 -2.2070112830e-01 -410 4.1000000000e+00 -8.8852357090e-02 -2.1999541830e-01 -411 4.1100000000e+00 -8.6658837090e-02 -2.1888407060e-01 -412 4.1200000000e+00 -8.4478336830e-02 -2.1738813900e-01 -413 4.1300000000e+00 -8.2314251940e-02 -2.1557604180e-01 -414 4.1400000000e+00 -8.0169437390e-02 -2.1350571680e-01 -415 4.1500000000e+00 -7.8046207450e-02 -2.1123112730e-01 -416 4.1600000000e+00 -7.5946335690e-02 -2.0880628380e-01 -417 4.1700000000e+00 -7.3871055030e-02 -2.0628522250e-01 -418 4.1800000000e+00 -7.1821057660e-02 -2.0372199140e-01 -419 4.1900000000e+00 -6.9796495110e-02 -2.0117226580e-01 -420 4.2000000000e+00 -6.7796978220e-02 -1.9869515570e-01 -421 4.2100000000e+00 -6.5821640000e-02 -1.9632881020e-01 -422 4.2200000000e+00 -6.3869449890e-02 -1.9406713000e-01 -423 4.2300000000e+00 -6.1939528000e-02 -1.9188425280e-01 -424 4.2400000000e+00 -6.0031208040e-02 -1.8975732620e-01 -425 4.2500000000e+00 -5.8144037210e-02 -1.8766499860e-01 -426 4.2600000000e+00 -5.6277776300e-02 -1.8558591260e-01 -427 4.2700000000e+00 -5.4432399640e-02 -1.8349871850e-01 -428 4.2800000000e+00 -5.2608095090e-02 -1.8138206230e-01 -429 4.2900000000e+00 -5.0805264080e-02 -1.7921412530e-01 -430 4.3000000000e+00 -4.9024521580e-02 -1.7697218360e-01 -431 4.3100000000e+00 -4.7266676850e-02 -1.7463962540e-01 -432 4.3200000000e+00 -4.5532637180e-02 -1.7221329340e-01 -433 4.3300000000e+00 -4.3823311560e-02 -1.6969643540e-01 -434 4.3400000000e+00 -4.2139591520e-02 -1.6709130180e-01 -435 4.3500000000e+00 -4.0482351020e-02 -1.6439964880e-01 -436 4.3600000000e+00 -3.8852446520e-02 -1.6162322490e-01 -437 4.3700000000e+00 -3.7250716970e-02 -1.5876378180e-01 -438 4.3800000000e+00 -3.5677983800e-02 -1.5582307140e-01 -439 4.3900000000e+00 -3.4135050920e-02 -1.5280279030e-01 -440 4.4000000000e+00 -3.2622704710e-02 -1.4970451960e-01 -441 4.4100000000e+00 -3.1141711720e-02 -1.4653058420e-01 -442 4.4200000000e+00 -2.9692807030e-02 -1.4328494170e-01 -443 4.4300000000e+00 -2.8276682610e-02 -1.3997231400e-01 -444 4.4400000000e+00 -2.6893985010e-02 -1.3659730260e-01 -445 4.4500000000e+00 -2.5545315350e-02 -1.3316445100e-01 -446 4.4600000000e+00 -2.4231229320e-02 -1.2967830180e-01 -447 4.4700000000e+00 -2.2952237190e-02 -1.2614339590e-01 -448 4.4800000000e+00 -2.1708803810e-02 -1.2256427830e-01 -449 4.4900000000e+00 -2.0501348580e-02 -1.1894531750e-01 -450 4.5000000000e+00 -1.9330245510e-02 -1.1529053780e-01 -451 4.5100000000e+00 -1.8195816190e-02 -1.1160621010e-01 -452 4.5200000000e+00 -1.7098295100e-02 -1.0790348070e-01 -453 4.5300000000e+00 -1.6037794770e-02 -1.0419576570e-01 -454 4.5400000000e+00 -1.5014298890e-02 -1.0049612610e-01 -455 4.5500000000e+00 -1.4027662260e-02 -9.6817447880e-02 -456 4.5600000000e+00 -1.3077610840e-02 -9.3172619330e-02 -457 4.5700000000e+00 -1.2163741680e-02 -8.9574526510e-02 -458 4.5800000000e+00 -1.1285523010e-02 -8.6036054070e-02 -459 4.5900000000e+00 -1.0442294160e-02 -8.2570683340e-02 -460 4.6000000000e+00 -9.6332655980e-03 -7.9193083800e-02 -461 4.6100000000e+00 -8.8575419760e-03 -7.5910311180e-02 -462 4.6200000000e+00 -8.1142373740e-03 -7.2713282330e-02 -463 4.6300000000e+00 -7.4025905500e-03 -6.9585550720e-02 -464 4.6400000000e+00 -6.7219879870e-03 -6.6511783650e-02 -465 4.6500000000e+00 -6.0719638950e-03 -6.3477208480e-02 -466 4.6600000000e+00 -5.4522002110e-03 -6.0467053010e-02 -467 4.6700000000e+00 -4.8625265960e-03 -5.7466544920e-02 -468 4.6800000000e+00 -4.3029204390e-03 -5.4460911670e-02 -469 4.6900000000e+00 -3.7735068550e-03 -5.1434523580e-02 -470 4.7000000000e+00 -3.2745586850e-03 -4.8370043780e-02 -471 4.7100000000e+00 -2.8064617420e-03 -4.5261307720e-02 -472 4.7200000000e+00 -2.3695410370e-03 -4.2126515780e-02 -473 4.7300000000e+00 -1.9638870030e-03 -3.8995268370e-02 -474 4.7400000000e+00 -1.5893207430e-03 -3.5895375370e-02 -475 4.7500000000e+00 -1.2453940290e-03 -3.2853768170e-02 -476 4.7600000000e+00 -9.3138930210e-04 -2.9897377850e-02 -477 4.7700000000e+00 -6.4631967200e-04 -2.7053134890e-02 -478 4.7800000000e+00 -3.8892891730e-04 -2.4347968780e-02 -479 4.7900000000e+00 -1.5769148580e-04 -2.1809973910e-02 -480 4.8000000000e+00 4.9187505960e-05 -1.9469671160e-02 -481 4.8100000000e+00 2.3372925440e-04 -1.7342891530e-02 -482 4.8200000000e+00 3.9796617840e-04 -1.5415189150e-02 -483 4.8300000000e+00 5.4372682880e-04 -1.3658952380e-02 -484 4.8400000000e+00 6.7259287050e-04 -1.2048522610e-02 -485 4.8500000000e+00 7.8589908240e-04 -1.0559209690e-02 -486 4.8600000000e+00 8.8473335710e-04 -9.1663247630e-03 -487 4.8700000000e+00 9.6993670140e-04 -7.8451808230e-03 -488 4.8800000000e+00 1.0421032360e-03 -6.5710929150e-03 -489 4.8900000000e+00 1.1015801950e-03 -5.3185837070e-03 -490 4.9000000000e+00 1.1484679270e-03 -4.0606536610e-03 -491 4.9100000000e+00 1.1826519980e-03 -2.7805919490e-03 -492 4.9200000000e+00 1.2039636980e-03 -1.4840911740e-03 -493 4.9300000000e+00 1.2123405590e-03 -1.8744637850e-04 -494 4.9400000000e+00 1.2078584520e-03 1.0946955090e-03 -495 4.9500000000e+00 1.1907315900e-03 2.3485018540e-03 -496 4.9600000000e+00 1.1613125250e-03 3.5601402240e-03 -497 4.9700000000e+00 1.1200921520e-03 4.7157788300e-03 -498 4.9800000000e+00 1.0676997050e-03 5.8015868510e-03 -499 4.9900000000e+00 1.0049027610e-03 6.8031822230e-03 -500 5.0000000000e+00 9.3260723520e-04 7.7050078140e-03 -501 5.0100000000e+00 8.5183745480e-04 8.4983969340e-03 -502 5.0200000000e+00 7.6363650240e-04 9.1887805930e-03 -503 5.0300000000e+00 6.6896656300e-04 9.7875612980e-03 -504 5.0400000000e+00 5.6868899310e-04 1.0305252310e-02 -505 5.0500000000e+00 4.6356432080e-04 1.0751939230e-02 -506 5.0600000000e+00 3.5425224560e-04 1.1137708580e-02 -507 5.0700000000e+00 2.4131163850e-04 1.1472647570e-02 -508 5.0800000000e+00 1.2520054220e-04 1.1766843320e-02 -509 5.0900000000e+00 6.2761706890e-06 1.2030583530e-02 -510 5.1000000000e+00 -1.1520509050e-04 1.2274519120e-02 -511 5.1100000000e+00 -2.3908004220e-04 1.2506742270e-02 -512 5.1200000000e+00 -3.6524046290e-04 1.2730078350e-02 -513 5.1300000000e+00 -4.9359489830e-04 1.2944907750e-02 -514 5.1400000000e+00 -6.2406102030e-04 1.3151960710e-02 -515 5.1500000000e+00 -7.5656562640e-04 1.3352149800e-02 -516 5.1600000000e+00 -8.9104464010e-04 1.3546387640e-02 -517 5.1700000000e+00 -1.0274431110e-03 1.3735586810e-02 -518 5.1800000000e+00 -1.1657152140e-03 1.3920659690e-02 -519 5.1900000000e+00 -1.3058242490e-03 1.4102349940e-02 -520 5.2000000000e+00 -1.4477426450e-03 1.4281081480e-02 -521 5.2100000000e+00 -1.5914586660e-03 1.4459496790e-02 -522 5.2200000000e+00 -1.7370099740e-03 1.4644838790e-02 -523 5.2300000000e+00 -1.8845171920e-03 1.4846534220e-02 -524 5.2400000000e+00 -2.0341906130e-03 1.5073718280e-02 -525 5.2500000000e+00 -2.1863302000e-03 1.5335361050e-02 -526 5.2600000000e+00 -2.3413255880e-03 1.5640434670e-02 -527 5.2700000000e+00 -2.4996560810e-03 1.5997911230e-02 -528 5.2800000000e+00 -2.6618906560e-03 1.6416762160e-02 -529 5.2900000000e+00 -2.8286879610e-03 1.6906373970e-02 -530 5.3000000000e+00 -3.0007963120e-03 1.7477007110e-02 -531 5.3100000000e+00 -3.1790339990e-03 1.8133074970e-02 -532 5.3200000000e+00 -3.3641907710e-03 1.8865012170e-02 -533 5.3300000000e+00 -3.5569293410e-03 1.9656413040e-02 -534 5.3400000000e+00 -3.7577656750e-03 2.0492060870e-02 -535 5.3500000000e+00 -3.9670690000e-03 2.1357287210e-02 -536 5.3600000000e+00 -4.1850618000e-03 2.2237421170e-02 -537 5.3700000000e+00 -4.4118198130e-03 2.3117792040e-02 -538 5.3800000000e+00 -4.6472720400e-03 2.3983729020e-02 -539 5.3900000000e+00 -4.8912007360e-03 2.4820173120e-02 -540 5.4000000000e+00 -5.1432414150e-03 2.5611246230e-02 -541 5.4100000000e+00 -5.4028974590e-03 2.6345995690e-02 -542 5.4200000000e+00 -5.6696131800e-03 2.7023783330e-02 -543 5.4300000000e+00 -5.9428468820e-03 2.7648494840e-02 -544 5.4400000000e+00 -6.2220854650e-03 2.8223326690e-02 -545 5.4500000000e+00 -6.5068444350e-03 2.8751139070e-02 -546 5.4600000000e+00 -6.7966678950e-03 2.9234792020e-02 -547 5.4700000000e+00 -7.0911285520e-03 2.9677145900e-02 -548 5.4800000000e+00 -7.3898277130e-03 3.0081060730e-02 -549 5.4900000000e+00 -7.6923952860e-03 3.0449630790e-02 -550 5.5000000000e+00 -7.9984897810e-03 3.0786428800e-02 -551 5.5100000000e+00 -8.3077897170e-03 3.1092132900e-02 -552 5.5200000000e+00 -8.6199506760e-03 3.1361354280e-02 -553 5.5300000000e+00 -8.9345623430e-03 3.1586068180e-02 -554 5.5400000000e+00 -9.2511399250e-03 3.1758727190e-02 -555 5.5500000000e+00 -9.5691241460e-03 3.1872314690e-02 -556 5.5600000000e+00 -9.8878812460e-03 3.1879060490e-02 -557 5.5700000000e+00 -1.0206702980e-02 3.1879343290e-02 -558 5.5800000000e+00 -1.0524806640e-02 3.1775291070e-02 -559 5.5900000000e+00 -1.0841335000e-02 3.1575078260e-02 -560 5.6000000000e+00 -1.1155356390e-02 3.1277094940e-02 -561 5.6100000000e+00 -1.1465874190e-02 3.0876002420e-02 -562 5.6200000000e+00 -1.1771874720e-02 3.0373359010e-02 -563 5.6300000000e+00 -1.2072375040e-02 2.9774158060e-02 -564 5.6400000000e+00 -1.2366432510e-02 2.9082718780e-02 -565 5.6500000000e+00 -1.2653144820e-02 2.8303067980e-02 -566 5.6600000000e+00 -1.2931649940e-02 2.7439235100e-02 -567 5.6700000000e+00 -1.3201126190e-02 2.6495251650e-02 -568 5.6800000000e+00 -1.3460792170e-02 2.5475145970e-02 -569 5.6900000000e+00 -1.3709906810e-02 2.4382869130e-02 -570 5.7000000000e+00 -1.3947769340e-02 2.3222203640e-02 -571 5.7100000000e+00 -1.4173722750e-02 2.1998018300e-02 -572 5.7200000000e+00 -1.4387171000e-02 2.0717601730e-02 -573 5.7300000000e+00 -1.4587596210e-02 1.9389388150e-02 -574 5.7400000000e+00 -1.4774562110e-02 1.8021631230e-02 -575 5.7500000000e+00 -1.4947714070e-02 1.6622492240e-02 -576 5.7600000000e+00 -1.5106779050e-02 1.5200129840e-02 -577 5.7700000000e+00 -1.5251565630e-02 1.3762707810e-02 -578 5.7800000000e+00 -1.5381964020e-02 1.2318387210e-02 -579 5.7900000000e+00 -1.5497946030e-02 1.0875476430e-02 -580 5.8000000000e+00 -1.5599565090e-02 9.4425870750e-03 -581 5.8100000000e+00 -1.5686950370e-02 8.0264086870e-03 -582 5.8200000000e+00 -1.5760277400e-02 6.6295090340e-03 -583 5.8300000000e+00 -1.5819738700e-02 5.2525609880e-03 -584 5.8400000000e+00 -1.5865537890e-02 3.8965319600e-03 -585 5.8500000000e+00 -1.5897889720e-02 2.5625313690e-03 -586 5.8600000000e+00 -1.5917020020e-02 1.2516718340e-03 -587 5.8700000000e+00 -1.5923165770e-02 -3.4937058100e-05 -588 5.8800000000e+00 -1.5916575010e-02 -1.2961843800e-03 -589 5.8900000000e+00 -1.5897506940e-02 -2.5310939070e-03 -590 5.9000000000e+00 -1.5866231840e-02 -3.7389705170e-03 -591 5.9100000000e+00 -1.5823036470e-02 -4.9173578470e-03 -592 5.9200000000e+00 -1.5768250830e-02 -6.0600357120e-03 -593 5.9300000000e+00 -1.5702275000e-02 -7.1590688840e-03 -594 5.9400000000e+00 -1.5625584430e-02 -8.2067883000e-03 -595 5.9500000000e+00 -1.5538730000e-02 -9.1956535530e-03 -596 5.9600000000e+00 -1.5442337980e-02 -1.0118124370e-02 -597 5.9700000000e+00 -1.5337110070e-02 -1.0966662250e-02 -598 5.9800000000e+00 -1.5223823350e-02 -1.1733731860e-02 -599 5.9900000000e+00 -1.5103330310e-02 -1.2411346770e-02 -600 6.0000000000e+00 -1.4976558850e-02 -1.2990539800e-02 -601 6.0100000000e+00 -1.4844496760e-02 -1.3467852250e-02 -602 6.0200000000e+00 -1.4708114030e-02 -1.3850882370e-02 -603 6.0300000000e+00 -1.4568285260e-02 -1.4151686870e-02 -604 6.0400000000e+00 -1.4425774100e-02 -1.4381668920e-02 -605 6.0500000000e+00 -1.4281233220e-02 -1.4551925990e-02 -606 6.0600000000e+00 -1.4135204390e-02 -1.4673570400e-02 -607 6.0700000000e+00 -1.3988118420e-02 -1.4757756220e-02 -608 6.0800000000e+00 -1.3840295150e-02 -1.4815688990e-02 -609 6.0900000000e+00 -1.3691943500e-02 -1.4859029650e-02 -610 6.1000000000e+00 -1.3543161430e-02 -1.4899772950e-02 -611 6.1100000000e+00 -1.3393954760e-02 -1.4944650430e-02 -612 6.1200000000e+00 -1.3244331080e-02 -1.4987875210e-02 -613 6.1300000000e+00 -1.3094393730e-02 -1.4999195980e-02 -614 6.1400000000e+00 -1.2944360580e-02 -1.5000406620e-02 -615 6.1500000000e+00 -1.2794564020e-02 -1.4968741120e-02 -616 6.1600000000e+00 -1.2645450970e-02 -1.4878631960e-02 -617 6.1700000000e+00 -1.2497582900e-02 -1.4726360280e-02 -618 6.1800000000e+00 -1.2351635780e-02 -1.4500650680e-02 -619 6.1900000000e+00 -1.2208400130e-02 -1.4189602640e-02 -620 6.2000000000e+00 -1.2068780980e-02 -1.3780088450e-02 -621 6.2100000000e+00 -1.1933770350e-02 -1.3266656360e-02 -622 6.2200000000e+00 -1.1804309490e-02 -1.2663757970e-02 -623 6.2300000000e+00 -1.1681151160e-02 -1.1995648740e-02 -624 6.2400000000e+00 -1.1564832050e-02 -1.1284711830e-02 -625 6.2500000000e+00 -1.1455672780e-02 -1.0552530900e-02 -626 6.2600000000e+00 -1.1353777930e-02 -9.8206944580e-03 -627 6.2700000000e+00 -1.1259036020e-02 -9.1107917220e-03 -628 6.2800000000e+00 -1.1171119520e-02 -8.4444087170e-03 -629 6.2900000000e+00 -1.1089484820e-02 -7.8440382630e-03 -630 6.3000000000e+00 -1.1013372280e-02 -7.3343059900e-03 -631 6.3100000000e+00 -1.0941837570e-02 -6.9286062890e-03 -632 6.3200000000e+00 -1.0873908590e-02 -6.6177004520e-03 -633 6.3300000000e+00 -1.0808742380e-02 -6.3836149380e-03 -634 6.3400000000e+00 -1.0745656480e-02 -6.2096675710e-03 -635 6.3500000000e+00 -1.0684128980e-02 -6.0797276050e-03 -636 6.3600000000e+00 -1.0623798440e-02 -5.9776679450e-03 -637 6.3700000000e+00 -1.0564463980e-02 -5.8875005540e-03 -638 6.3800000000e+00 -1.0506085210e-02 -5.7934100960e-03 -639 6.3900000000e+00 -1.0448782260e-02 -5.6790958870e-03 -640 6.4000000000e+00 -1.0392835790e-02 -5.5272351870e-03 -641 6.4100000000e+00 -1.0338663800e-02 -5.3265489450e-03 -642 6.4200000000e+00 -1.0286705990e-02 -5.0824779890e-03 -643 6.4300000000e+00 -1.0237307970e-02 -4.8090647670e-03 -644 6.4400000000e+00 -1.0190698140e-02 -4.5186980020e-03 -645 6.4500000000e+00 -1.0146987700e-02 -4.2230772190e-03 -646 6.4600000000e+00 -1.0106170660e-02 -3.9339072730e-03 -647 6.4700000000e+00 -1.0068123810e-02 -3.6628907880e-03 -648 6.4800000000e+00 -1.0032606730e-02 -3.4217128560e-03 -649 6.4900000000e+00 -9.9992617940e-03 -3.2226936060e-03 -650 6.5000000000e+00 -9.9676141880e-03 -3.0800614930e-03 -651 6.5100000000e+00 -9.9370921530e-03 -3.0007974900e-03 -652 6.5200000000e+00 -9.9071283790e-03 -2.9895971810e-03 -653 6.5300000000e+00 -9.8772613860e-03 -2.9909390270e-03 -654 6.5400000000e+00 -9.8471557910e-03 -3.0244442110e-03 -655 6.5500000000e+00 -9.8166023160e-03 -3.0807584720e-03 -656 6.5600000000e+00 -9.7855177830e-03 -3.1389446580e-03 -657 6.5700000000e+00 -9.7539451160e-03 -3.1876831780e-03 -658 6.5800000000e+00 -9.7220533400e-03 -3.1902459520e-03 -659 6.5900000000e+00 -9.6901375810e-03 -3.1905666810e-03 -660 6.6000000000e+00 -9.6586190680e-03 -3.1317577790e-03 -661 6.6100000000e+00 -9.6280205840e-03 -3.0113946400e-03 -662 6.6200000000e+00 -9.5988437380e-03 -2.8430708940e-03 -663 6.6300000000e+00 -9.5714462370e-03 -2.6468063050e-03 -664 6.6400000000e+00 -9.5460173390e-03 -2.4401082740e-03 -665 6.6500000000e+00 -9.5225778510e-03 -2.2397114760e-03 -666 6.6600000000e+00 -9.5009801320e-03 -2.0623027660e-03 -667 6.6700000000e+00 -9.4809080910e-03 -1.9242058160e-03 -668 6.6800000000e+00 -9.4618771900e-03 -1.8756816070e-03 -669 6.6900000000e+00 -9.4432344390e-03 -1.8737538630e-03 -670 6.7000000000e+00 -9.4241584000e-03 -1.9296967320e-03 -671 6.7100000000e+00 -9.4036962210e-03 -2.1193480020e-03 -672 6.7200000000e+00 -9.3809488110e-03 -2.3946186600e-03 -673 6.7300000000e+00 -9.3552560140e-03 -2.7229160010e-03 -674 6.7400000000e+00 -9.3262336490e-03 -3.0756765770e-03 -675 6.7500000000e+00 -9.2937735010e-03 -3.4254765850e-03 -676 6.7600000000e+00 -9.2580433320e-03 -3.7449102950e-03 -677 6.7700000000e+00 -9.2194868700e-03 -4.0068658770e-03 -678 6.7800000000e+00 -9.1788238190e-03 -4.1695216600e-03 -679 6.7900000000e+00 -9.1370498500e-03 -4.1709417970e-03 -680 6.8000000000e+00 -9.0954366100e-03 -4.1531823070e-03 -681 6.8100000000e+00 -9.0554785850e-03 -3.9087191710e-03 -682 6.8200000000e+00 -9.0186274690e-03 -3.5228649830e-03 -683 6.8300000000e+00 -8.9860265190e-03 -3.0396673600e-03 -684 6.8400000000e+00 -8.9584574300e-03 -2.4966871920e-03 -685 6.8500000000e+00 -8.9363403360e-03 -1.9298633360e-03 -686 6.8600000000e+00 -8.9197338070e-03 -1.3752156630e-03 -687 6.8700000000e+00 -8.9083348510e-03 -8.6872626790e-04 -688 6.8800000000e+00 -8.9014789130e-03 -4.4613382030e-04 -689 6.8900000000e+00 -8.8981398760e-03 -1.4464164490e-04 -690 6.9000000000e+00 -8.8969300610e-03 -9.3306974460e-05 -691 6.9100000000e+00 -8.8961599030e-03 -9.4842573110e-05 -692 6.9200000000e+00 -8.8941363350e-03 -2.6951752300e-04 -693 6.9300000000e+00 -8.8894611720e-03 -6.0677709890e-04 -694 6.9400000000e+00 -8.8810907890e-03 -1.0295850060e-03 -695 6.9500000000e+00 -8.8683361180e-03 -1.5032386040e-03 -696 6.9600000000e+00 -8.8508626520e-03 -1.9925371240e-03 -697 6.9700000000e+00 -8.8286904430e-03 -2.4622017850e-03 -698 6.9800000000e+00 -8.8021941000e-03 -2.8770558440e-03 -699 6.9900000000e+00 -8.7721027940e-03 -3.2001665000e-03 -700 7.0000000000e+00 -8.7395002530e-03 -3.3628110830e-03 -701 7.0100000000e+00 -8.7057669680e-03 -3.3616587300e-03 -702 7.0200000000e+00 -8.6722912150e-03 -3.3328724970e-03 -703 7.0300000000e+00 -8.6401800780e-03 -3.1369921780e-03 -704 7.0400000000e+00 -8.6102016490e-03 -2.8836524560e-03 -705 7.0500000000e+00 -8.5827850310e-03 -2.6048254500e-03 -706 7.0600000000e+00 -8.5580203390e-03 -2.3338108210e-03 -707 7.0700000000e+00 -8.5356586960e-03 -2.1036368350e-03 -708 7.0800000000e+00 -8.5151122380e-03 -1.9811072220e-03 -709 7.0900000000e+00 -8.4954541080e-03 -1.9777398690e-03 -710 7.1000000000e+00 -8.4754184640e-03 -2.0225113290e-03 -711 7.1100000000e+00 -8.4534593770e-03 -2.2965828040e-03 -712 7.1200000000e+00 -8.4280453800e-03 -2.7212170120e-03 -713 7.1300000000e+00 -8.3979540000e-03 -3.2510514740e-03 -714 7.1400000000e+00 -8.3623306660e-03 -3.8476514650e-03 -715 7.1500000000e+00 -8.3206887140e-03 -4.4744244140e-03 -716 7.1600000000e+00 -8.2729093820e-03 -5.0946981770e-03 -717 7.1700000000e+00 -8.2192418120e-03 -5.6718145680e-03 -718 7.1800000000e+00 -8.1603030520e-03 -6.1692539840e-03 -719 7.1900000000e+00 -8.0970780500e-03 -6.5487676050e-03 -720 7.2000000000e+00 -8.0309196620e-03 -6.7272229100e-03 -721 7.2100000000e+00 -7.9634907270e-03 -6.7259642140e-03 -722 7.2200000000e+00 -7.8964744890e-03 -6.6789598430e-03 -723 7.2300000000e+00 -7.8312850050e-03 -6.4221789350e-03 -724 7.2400000000e+00 -7.7690092330e-03 -6.0751032250e-03 -725 7.2500000000e+00 -7.7104070320e-03 -5.6689224870e-03 -726 7.2600000000e+00 -7.6559111550e-03 -5.2359769820e-03 -727 7.2700000000e+00 -7.6056272590e-03 -4.8087903910e-03 -728 7.2800000000e+00 -7.5593338980e-03 -4.4198555860e-03 -729 7.2900000000e+00 -7.5164825260e-03 -4.1030087070e-03 -730 7.3000000000e+00 -7.4761974950e-03 -3.8973776310e-03 -731 7.3100000000e+00 -7.4373205220e-03 -3.8759720650e-03 -732 7.3200000000e+00 -7.3986330090e-03 -3.8773675230e-03 -733 7.3300000000e+00 -7.3590783700e-03 -4.0015934670e-03 -734 7.3400000000e+00 -7.3178064890e-03 -4.2169764230e-03 -735 7.3500000000e+00 -7.2741737280e-03 -4.4858423140e-03 -736 7.3600000000e+00 -7.2277429200e-03 -4.7879201620e-03 -737 7.3700000000e+00 -7.1782833720e-03 -5.1026918510e-03 -738 7.3800000000e+00 -7.1257708670e-03 -5.4095927810e-03 -739 7.3900000000e+00 -7.0703876590e-03 -5.6872718710e-03 -740 7.4000000000e+00 -7.0125224790e-03 -5.9122800580e-03 -741 7.4100000000e+00 -6.9527445490e-03 -6.0705847630e-03 -742 7.4200000000e+00 -6.8916736910e-03 -6.1675051450e-03 -743 7.4300000000e+00 -6.8298504240e-03 -6.2135136040e-03 -744 7.4400000000e+00 -6.7677099870e-03 -6.2133123600e-03 -745 7.4500000000e+00 -6.7055823390e-03 -6.2119432270e-03 -746 7.4600000000e+00 -6.6436921590e-03 -6.1750902160e-03 -747 7.4700000000e+00 -6.5821588440e-03 -6.1325376130e-03 -748 7.4800000000e+00 -6.5209965140e-03 -6.0933858940e-03 -749 7.4900000000e+00 -6.4601140040e-03 -6.0833932360e-03 -750 7.5000000000e+00 -6.3993148730e-03 -6.0828678280e-03 -751 7.5100000000e+00 -6.3383152770e-03 -6.1110319720e-03 -752 7.5200000000e+00 -6.2768333710e-03 -6.1744378110e-03 -753 7.5300000000e+00 -6.2146787090e-03 -6.2517322550e-03 -754 7.5400000000e+00 -6.1517701230e-03 -6.3316236530e-03 -755 7.5500000000e+00 -6.0881357210e-03 -6.4034456450e-03 -756 7.5600000000e+00 -6.0239128920e-03 -6.4556549940e-03 -757 7.5700000000e+00 -5.9593483000e-03 -6.4558690390e-03 -758 7.5800000000e+00 -5.8947978880e-03 -6.4544047390e-03 -759 7.5900000000e+00 -5.8307268780e-03 -6.3840366970e-03 -760 7.6000000000e+00 -5.7677097690e-03 -6.2482392170e-03 -761 7.6100000000e+00 -5.7064038390e-03 -6.0415350870e-03 -762 7.6200000000e+00 -5.6474166590e-03 -5.7781975640e-03 -763 7.6300000000e+00 -5.5911735990e-03 -5.4820877910e-03 -764 7.6400000000e+00 -5.5378913320e-03 -5.1747939830e-03 -765 7.6500000000e+00 -5.4875778360e-03 -4.8770962220e-03 -766 7.6600000000e+00 -5.4400323880e-03 -4.6097357670e-03 -767 7.6700000000e+00 -5.3948455730e-03 -4.3932287400e-03 -768 7.6800000000e+00 -5.3513992750e-03 -4.2592350550e-03 -769 7.6900000000e+00 -5.3088666840e-03 -4.2582276760e-03 -770 7.7000000000e+00 -5.2662122910e-03 -4.2715994810e-03 -771 7.7100000000e+00 -5.2222317010e-03 -4.4675543320e-03 -772 7.7200000000e+00 -5.1757506940e-03 -4.7782011870e-03 -773 7.7300000000e+00 -5.1258242750e-03 -5.1707250140e-03 -774 7.7400000000e+00 -5.0717764940e-03 -5.6171552670e-03 -775 7.7500000000e+00 -5.0132004380e-03 -6.0907404020e-03 -776 7.7600000000e+00 -4.9499582360e-03 -6.5646596010e-03 -777 7.7700000000e+00 -4.8821810580e-03 -7.0120917520e-03 -778 7.7800000000e+00 -4.8102691140e-03 -7.4062816260e-03 -779 7.7900000000e+00 -4.7348916560e-03 -7.7192866600e-03 -780 7.8000000000e+00 -4.6569869740e-03 -7.9185010720e-03 -781 7.8100000000e+00 -4.5777234760e-03 -7.9357116620e-03 -782 7.8200000000e+00 -4.4983050530e-03 -7.9345538390e-03 -783 7.8300000000e+00 -4.4197764540e-03 -7.8056778610e-03 -784 7.8400000000e+00 -4.3429843580e-03 -7.5886231250e-03 -785 7.8500000000e+00 -4.2685773750e-03 -7.3171269070e-03 -786 7.8600000000e+00 -4.1970060460e-03 -7.0106527050e-03 -787 7.8700000000e+00 -4.1285228410e-03 -6.6888898820e-03 -788 7.8800000000e+00 -4.0631821630e-03 -6.3715753420e-03 -789 7.8900000000e+00 -4.0008403430e-03 -6.0790957490e-03 -790 7.9000000000e+00 -3.9411556450e-03 -5.8334960980e-03 -791 7.9100000000e+00 -3.8836100890e-03 -5.6490249270e-03 -792 7.9200000000e+00 -3.8276185730e-03 -5.5238274960e-03 -793 7.9300000000e+00 -3.7726380060e-03 -5.4503718460e-03 -794 7.9400000000e+00 -3.7181891260e-03 -5.4368290110e-03 -795 7.9500000000e+00 -3.6638565070e-03 -5.4375412710e-03 -796 7.9600000000e+00 -3.6092885500e-03 -5.4693271350e-03 -797 7.9700000000e+00 -3.5541974930e-03 -5.5364281040e-03 -798 7.9800000000e+00 -3.4983594020e-03 -5.6225227740e-03 -799 7.9900000000e+00 -3.4416141800e-03 -5.7213422600e-03 -800 8.0000000000e+00 -3.3838655570e-03 -5.8264552150e-03 -801 8.0100000000e+00 -3.3250799920e-03 -5.9317600090e-03 -802 8.0200000000e+00 -3.2652811390e-03 -6.0319529100e-03 -803 8.0300000000e+00 -3.2045443190e-03 -6.1220872130e-03 -804 8.0400000000e+00 -3.1429954090e-03 -6.1971772310e-03 -805 8.0500000000e+00 -3.0808108470e-03 -6.2523344830e-03 -806 8.0600000000e+00 -3.0182176310e-03 -6.2681669500e-03 -807 8.0700000000e+00 -2.9554933170e-03 -6.2687770620e-03 -808 8.0800000000e+00 -2.8929660200e-03 -6.2432932110e-03 -809 8.0900000000e+00 -2.8310144160e-03 -6.1668903030e-03 -810 8.1000000000e+00 -2.7700677390e-03 -6.0438459020e-03 -811 8.1100000000e+00 -2.7105918050e-03 -5.8720071740e-03 -812 8.1200000000e+00 -2.6530191240e-03 -5.6595409670e-03 -813 8.1300000000e+00 -2.5976790150e-03 -5.4196416380e-03 -814 8.1400000000e+00 -2.5447836260e-03 -5.1644165190e-03 -815 8.1500000000e+00 -2.4944279380e-03 -4.9055584030e-03 -816 8.1600000000e+00 -2.4465897580e-03 -4.6547632950e-03 -817 8.1700000000e+00 -2.4011297280e-03 -4.4237188540e-03 -818 8.1800000000e+00 -2.3577913170e-03 -4.2240813640e-03 -819 8.1900000000e+00 -2.3162008250e-03 -4.0681406080e-03 -820 8.2000000000e+00 -2.2758673830e-03 -3.9706319740e-03 -821 8.2100000000e+00 -2.2362029790e-03 -3.9611717460e-03 -822 8.2200000000e+00 -2.1966225940e-03 -3.9620151530e-03 -823 8.2300000000e+00 -2.1566443350e-03 -4.0194821090e-03 -824 8.2400000000e+00 -2.1159094640e-03 -4.1138208480e-03 -825 8.2500000000e+00 -2.0741823980e-03 -4.2252451690e-03 -826 8.2600000000e+00 -2.0313507070e-03 -4.3416947870e-03 -827 8.2700000000e+00 -1.9874251180e-03 -4.4510024540e-03 -828 8.2800000000e+00 -1.9425395100e-03 -4.5411700940e-03 -829 8.2900000000e+00 -1.8969509160e-03 -4.5850896530e-03 -830 8.3000000000e+00 -1.8510395260e-03 -4.5858122980e-03 -831 8.3100000000e+00 -1.8052902620e-03 -4.5663005390e-03 -832 8.3200000000e+00 -1.7602006790e-03 -4.4744051230e-03 -833 8.3300000000e+00 -1.7161888630e-03 -4.3453380180e-03 -834 8.3400000000e+00 -1.6735750130e-03 -4.1893095180e-03 -835 8.3500000000e+00 -1.6325814350e-03 -4.0160059210e-03 -836 8.3600000000e+00 -1.5933325480e-03 -3.8351750510e-03 -837 8.3700000000e+00 -1.5558548830e-03 -3.6565797610e-03 -838 8.3800000000e+00 -1.5200770810e-03 -3.4899795860e-03 -839 8.3900000000e+00 -1.4858298910e-03 -3.3455567640e-03 -840 8.4000000000e+00 -1.4528461780e-03 -3.2346895450e-03 -841 8.4100000000e+00 -1.4207748020e-03 -3.1637014420e-03 -842 8.4200000000e+00 -1.3892500700e-03 -3.1291533650e-03 -843 8.4300000000e+00 -1.3579611770e-03 -3.1292408310e-03 -844 8.4400000000e+00 -1.3266660940e-03 -3.1298911790e-03 -845 8.4500000000e+00 -1.2951915690e-03 -3.1576610340e-03 -846 8.4600000000e+00 -1.2634331300e-03 -3.1917512150e-03 -847 8.4700000000e+00 -1.2313550790e-03 -3.2259651180e-03 -848 8.4800000000e+00 -1.1989904980e-03 -3.2540630400e-03 -849 8.4900000000e+00 -1.1664412430e-03 -3.2555693480e-03 -850 8.5000000000e+00 -1.1338779510e-03 -3.2557025210e-03 -851 8.5100000000e+00 -1.1015326060e-03 -3.2234865450e-03 -852 8.5200000000e+00 -1.0696614040e-03 -3.1630718910e-03 -853 8.5300000000e+00 -1.0385076140e-03 -3.0791159010e-03 -854 8.5400000000e+00 -1.0082941500e-03 -2.9739076870e-03 -855 8.5500000000e+00 -9.7922357050e-04 -2.8494714080e-03 -856 8.5600000000e+00 -9.5147808060e-04 -2.7078379130e-03 -857 8.5700000000e+00 -9.2521952960e-04 -2.5510405740e-03 -858 8.5800000000e+00 -9.0058941240e-04 -2.3811136250e-03 -859 8.5900000000e+00 -8.7770886890e-04 -2.2000297810e-03 -860 8.6000000000e+00 -8.5667868430e-04 -2.0096305180e-03 -861 8.6100000000e+00 -8.3757669380e-04 -1.8125777800e-03 -862 8.6200000000e+00 -8.2044480670e-04 -1.6133743580e-03 -863 8.6300000000e+00 -8.0527603090e-04 -1.4173768830e-03 -864 8.6400000000e+00 -7.9201187730e-04 -1.2297980360e-03 -865 8.6500000000e+00 -7.8054236030e-04 -1.0557824940e-03 -866 8.6600000000e+00 -7.7070599730e-04 -9.0047077190e-04 -867 8.6700000000e+00 -7.6228980900e-04 -7.6899201130e-04 -868 8.6800000000e+00 -7.5502931930e-04 -6.6643613270e-04 -869 8.6900000000e+00 -7.4860855550e-04 -5.9822957020e-04 -870 8.7000000000e+00 -7.4266004790e-04 -5.9102166820e-04 -871 8.7100000000e+00 -7.3677624910e-04 -5.9136220610e-04 -872 8.7200000000e+00 -7.3056662870e-04 -6.3841529490e-04 -873 8.7300000000e+00 -7.2371476810e-04 -7.1895190120e-04 -874 8.7400000000e+00 -7.1598977950e-04 -8.1806870680e-04 -875 8.7500000000e+00 -7.0724630570e-04 -9.2737467390e-04 -876 8.7600000000e+00 -6.9742452050e-04 -1.0383773450e-03 -877 8.7700000000e+00 -6.8655012820e-04 -1.1425742970e-03 -878 8.7800000000e+00 -6.7473436410e-04 -1.2315130470e-03 -879 8.7900000000e+00 -6.6217399400e-04 -1.2963584120e-03 -880 8.8000000000e+00 -6.4915131470e-04 -1.3094343440e-03 -881 8.8100000000e+00 -6.3601950570e-04 -1.3089678270e-03 -882 8.8200000000e+00 -6.2312938900e-04 -1.2757712740e-03 -883 8.8300000000e+00 -6.1075618940e-04 -1.2096983960e-03 -884 8.8400000000e+00 -5.9908488620e-04 -1.1299283140e-03 -885 8.8500000000e+00 -5.8821021300e-04 -1.0452584110e-03 -886 8.8600000000e+00 -5.7813665840e-04 -9.6460283190e-04 -887 8.8700000000e+00 -5.6877846530e-04 -8.9678568750e-04 -888 8.8800000000e+00 -5.5995963120e-04 -8.5822913660e-04 -889 8.8900000000e+00 -5.5141390820e-04 -8.5747478260e-04 -890 8.9000000000e+00 -5.4278480290e-04 -8.6716956740e-04 -891 8.9100000000e+00 -5.3364421720e-04 -9.4133837340e-04 -892 8.9200000000e+00 -5.2358565110e-04 -1.0544350220e-03 -893 8.9300000000e+00 -5.1231740570e-04 -1.1904098590e-03 -894 8.9400000000e+00 -4.9968122430e-04 -1.3354564220e-03 -895 8.9500000000e+00 -4.8565229150e-04 -1.4763473930e-03 -896 8.9600000000e+00 -4.7033923410e-04 -1.5999042110e-03 -897 8.9700000000e+00 -4.5398412050e-04 -1.6934097630e-03 -898 8.9800000000e+00 -4.3696246120e-04 -1.7112894550e-03 -899 8.9900000000e+00 -4.1978320830e-04 -1.7124335300e-03 -900 9.0000000000e+00 -4.0308875560e-04 -1.6449196520e-03 -901 9.0100000000e+00 -3.8762791010e-04 -1.4817040520e-03 -902 9.0200000000e+00 -3.7412074740e-04 -1.2491702780e-03 -903 9.0300000000e+00 -3.6312346700e-04 -9.6992461550e-04 -904 9.0400000000e+00 -3.5500136390e-04 -6.6380635360e-04 -905 9.0500000000e+00 -3.4992882860e-04 -3.4982061670e-04 -906 9.0600000000e+00 -3.4788934670e-04 -4.6993457500e-05 -907 9.0700000000e+00 -3.4867549920e-04 2.2568020250e-04 -908 9.0800000000e+00 -3.5188896250e-04 4.4935964540e-04 -909 9.0900000000e+00 -3.5694050820e-04 6.0452910960e-04 -910 9.1000000000e+00 -3.6305000340e-04 6.1763862860e-04 -911 9.1100000000e+00 -3.6927825380e-04 6.1715722710e-04 -912 9.1200000000e+00 -3.7468622130e-04 4.9717594620e-04 -913 9.1300000000e+00 -3.7849424120e-04 2.9714995560e-04 -914 9.1400000000e+00 -3.8011386570e-04 4.8341320950e-05 -915 9.1500000000e+00 -3.7914786360e-04 -2.3046620100e-04 -916 9.1600000000e+00 -3.7539022070e-04 -5.2026924870e-04 -917 9.1700000000e+00 -3.6882613980e-04 -8.0202351890e-04 -918 9.1800000000e+00 -3.5963204020e-04 -1.0567133440e-03 -919 9.1900000000e+00 -3.4817555830e-04 -1.2645602590e-03 -920 9.2000000000e+00 -3.3501554730e-04 -1.4029450680e-03 -921 9.2100000000e+00 -3.2087683960e-04 -1.4283913870e-03 -922 9.2200000000e+00 -3.0652406010e-04 -1.4272958700e-03 -923 9.2300000000e+00 -2.9263543830e-04 -1.3643256150e-03 -924 9.2400000000e+00 -2.7977757160e-04 -1.2322371450e-03 -925 9.2500000000e+00 -2.6840542450e-04 -1.0605904210e-03 -926 9.2600000000e+00 -2.5886232930e-04 -8.6031093940e-04 -927 9.2700000000e+00 -2.5137998560e-04 -6.4249036470e-04 -928 9.2800000000e+00 -2.4607846060e-04 -4.1825876870e-04 -929 9.2900000000e+00 -2.4296618900e-04 -1.9902305240e-04 -930 9.3000000000e+00 -2.4193997290e-04 3.1845693800e-06 -931 9.3100000000e+00 -2.4279467890e-04 1.7966093380e-04 -932 9.3200000000e+00 -2.4527172140e-04 3.2868016980e-04 -933 9.3300000000e+00 -2.4910754640e-04 4.5137591900e-04 -934 9.3400000000e+00 -2.5404332870e-04 5.4842279990e-04 -935 9.3500000000e+00 -2.5982497130e-04 6.2029030100e-04 -936 9.3600000000e+00 -2.6620310570e-04 6.6743896290e-04 -937 9.3700000000e+00 -2.7293309200e-04 6.8128886900e-04 -938 9.3800000000e+00 -2.7977501880e-04 6.8122989380e-04 -939 9.3900000000e+00 -2.8649370290e-04 6.6561682560e-04 -940 9.4000000000e+00 -2.9285868980e-04 6.1822347770e-04 -941 9.4100000000e+00 -2.9864964660e-04 5.4912675690e-04 -942 9.4200000000e+00 -3.0368332670e-04 4.6394228000e-04 -943 9.4300000000e+00 -3.0784053560e-04 3.7019047190e-04 -944 9.4400000000e+00 -3.1107152360e-04 2.7494326710e-04 -945 9.4500000000e+00 -3.1339598590e-04 1.8510907390e-04 -946 9.4600000000e+00 -3.1490306250e-04 1.0756448490e-04 -947 9.4700000000e+00 -3.1575133810e-04 4.8999593660e-05 -948 9.4800000000e+00 -3.1616884250e-04 3.3107920740e-05 -949 9.4900000000e+00 -3.1645305020e-04 3.2380561200e-05 -950 9.5000000000e+00 -3.1697088070e-04 6.3754272530e-05 -951 9.5100000000e+00 -3.1814184860e-04 1.5167878300e-04 -952 9.5200000000e+00 -3.2035381530e-04 2.7601805580e-04 -953 9.5300000000e+00 -3.2387874080e-04 4.2128484640e-04 -954 9.5400000000e+00 -3.2885583420e-04 5.7377933880e-04 -955 9.5500000000e+00 -3.3529155330e-04 7.2032706750e-04 -956 9.5600000000e+00 -3.4305960490e-04 8.4781313400e-04 -957 9.5700000000e+00 -3.5190094460e-04 9.4358916640e-04 -958 9.5800000000e+00 -3.6142377720e-04 9.6133332950e-04 -959 9.5900000000e+00 -3.7110355600e-04 9.6244725480e-04 -960 9.6000000000e+00 -3.8028298350e-04 8.9260370630e-04 -961 9.6100000000e+00 -3.8819947730e-04 7.2570100330e-04 -962 9.6200000000e+00 -3.9412250090e-04 4.8863488130e-04 -963 9.6300000000e+00 -3.9749089540e-04 2.0465082210e-04 -964 9.6400000000e+00 -3.9794034490e-04 -1.0580965950e-04 -965 9.6500000000e+00 -3.9530337710e-04 -4.2315129320e-04 -966 9.6600000000e+00 -3.8960936300e-04 -7.2775947590e-04 -967 9.6700000000e+00 -3.8108451720e-04 -1.0000584900e-03 -968 9.6800000000e+00 -3.7015189750e-04 -1.2206640990e-03 -969 9.6900000000e+00 -3.5743140510e-04 -1.3686784530e-03 -970 9.7000000000e+00 -3.4373978450e-04 -1.3687177910e-03 -971 9.7100000000e+00 -3.3005711180e-04 -1.3677771240e-03 -972 9.7200000000e+00 -3.1735923270e-04 -1.2175506400e-03 -973 9.7300000000e+00 -3.0645020200e-04 -9.9744243200e-04 -974 9.7400000000e+00 -2.9792877150e-04 -7.2818771020e-04 -975 9.7500000000e+00 -2.9218838950e-04 -4.3000627220e-04 -976 9.7600000000e+00 -2.8941720110e-04 -1.2331077010e-04 -977 9.7700000000e+00 -2.8959804820e-04 1.7145429420e-04 -978 9.7800000000e+00 -2.9250846960e-04 4.3389135570e-04 -979 9.7900000000e+00 -2.9772070050e-04 6.4262374950e-04 -980 9.8000000000e+00 -3.0460167320e-04 7.7223408700e-04 -981 9.8100000000e+00 -3.1234484370e-04 7.7669650150e-04 -982 9.8200000000e+00 -3.2012932700e-04 7.7621752470e-04 -983 9.8300000000e+00 -3.2727903260e-04 6.8055189370e-04 -984 9.8400000000e+00 -3.3329449150e-04 5.4117460460e-04 -985 9.8500000000e+00 -3.3785285590e-04 3.7873497620e-04 -986 9.8600000000e+00 -3.4080789960e-04 2.1056974260e-04 -987 9.8700000000e+00 -3.4219001780e-04 5.4129325750e-05 -988 9.8800000000e+00 -3.4220622720e-04 -7.3421138480e-05 -989 9.8900000000e+00 -3.4124016580e-04 -1.2932529480e-04 -990 9.9000000000e+00 -3.3985209320e-04 -1.3027960630e-04 -991 9.9100000000e+00 -3.3874868130e-04 -9.4889177100e-05 -992 9.9200000000e+00 -3.3863196930e-04 4.0847818400e-05 -993 9.9300000000e+00 -3.4004831890e-04 2.2224472680e-04 -994 9.9400000000e+00 -3.4335820470e-04 4.3012047260e-04 -995 9.9500000000e+00 -3.4873621490e-04 6.4610107190e-04 -996 9.9600000000e+00 -3.5617105070e-04 8.5173520200e-04 -997 9.9700000000e+00 -3.6546552680e-04 1.0286755720e-03 -998 9.9800000000e+00 -3.7623657080e-04 1.1593557180e-03 -999 9.9900000000e+00 -3.8791522390e-04 1.1761944840e-03 -1000 1.0000000000e+01 -3.9974664040e-04 1.1767838920e-03 -1001 1.0010000000e+01 -4.1082104180e-04 1.0677225170e-03 -1002 1.0020000000e+01 -4.2022926040e-04 8.5414149960e-04 -1003 1.0030000000e+01 -4.2721876140e-04 5.7407440180e-04 -1004 1.0040000000e+01 -4.3122515020e-04 2.4718443700e-04 -1005 1.0050000000e+01 -4.3187226610e-04 -1.0782601200e-04 -1006 1.0060000000e+01 -4.2897216000e-04 -4.7219506290e-04 -1007 1.0070000000e+01 -4.2252495590e-04 -8.2716579100e-04 -1008 1.0080000000e+01 -4.1271859740e-04 -1.1540259710e-03 -1009 1.0090000000e+01 -3.9992847830e-04 -1.4333717600e-03 -1010 1.0100000000e+01 -3.8471695790e-04 -1.6437078990e-03 -1011 1.0110000000e+01 -3.6780865340e-04 -1.7721885790e-03 -1012 1.0120000000e+01 -3.4996932360e-04 -1.8019117800e-03 -1013 1.0130000000e+01 -3.3188505560e-04 -1.8006379560e-03 -1014 1.0140000000e+01 -3.1413816540e-04 -1.7566778600e-03 -1015 1.0150000000e+01 -2.9720729950e-04 -1.6504364580e-03 -1016 1.0160000000e+01 -2.8146759970e-04 -1.5122390050e-03 -1017 1.0170000000e+01 -2.6719093180e-04 -1.3521402890e-03 -1018 1.0180000000e+01 -2.5454617650e-04 -1.1803480910e-03 -1019 1.0190000000e+01 -2.4359958460e-04 -1.0073204990e-03 -1020 1.0200000000e+01 -2.3431519470e-04 -8.4406428450e-04 -1021 1.0210000000e+01 -2.2656453160e-04 -6.9838951460e-04 -1022 1.0220000000e+01 -2.2017314520e-04 -5.7144880500e-04 -1023 1.0230000000e+01 -2.1496692380e-04 -4.6164139160e-04 -1024 1.0240000000e+01 -2.1078135050e-04 -3.6780651980e-04 -1025 1.0250000000e+01 -2.0746151260e-04 -2.8898365970e-04 -1026 1.0260000000e+01 -2.0486210460e-04 -2.2421250740e-04 -1027 1.0270000000e+01 -2.0284742580e-04 -1.7253368530e-04 -1028 1.0280000000e+01 -2.0129137260e-04 -1.3299015590e-04 -1029 1.0290000000e+01 -2.0007742360e-04 -1.0462481120e-04 -1030 1.0300000000e+01 -1.9909862130e-04 -8.6482093950e-05 -1031 1.0310000000e+01 -1.9825740620e-04 -8.0176145770e-05 -1032 1.0320000000e+01 -1.9746489060e-04 -8.0270475810e-05 -1033 1.0330000000e+01 -1.9664013180e-04 -8.4149519230e-05 -1034 1.0340000000e+01 -1.9570996480e-04 -9.8408753000e-05 -1035 1.0350000000e+01 -1.9460896870e-04 -1.1878674230e-04 -1036 1.0360000000e+01 -1.9327943030e-04 -1.4453939260e-04 -1037 1.0370000000e+01 -1.9167130140e-04 -1.7490855840e-04 -1038 1.0380000000e+01 -1.8974215350e-04 -2.0913698290e-04 -1039 1.0390000000e+01 -1.8745712570e-04 -2.4647791360e-04 -1040 1.0400000000e+01 -1.8478887050e-04 -2.8620364200e-04 -1041 1.0410000000e+01 -1.8171776410e-04 -3.2750670860e-04 -1042 1.0420000000e+01 -1.7823319480e-04 -3.6939422980e-04 -1043 1.0430000000e+01 -1.7433482900e-04 -4.1079442840e-04 -1044 1.0440000000e+01 -1.7003277440e-04 -4.5066219870e-04 -1045 1.0450000000e+01 -1.6534746400e-04 -4.8797153340e-04 -1046 1.0460000000e+01 -1.6030953380e-04 -5.2170945500e-04 -1047 1.0470000000e+01 -1.5495969400e-04 -5.5087748210e-04 -1048 1.0480000000e+01 -1.4934859350e-04 -5.7449468730e-04 -1049 1.0490000000e+01 -1.4353667910e-04 -5.9151095890e-04 -1050 1.0500000000e+01 -1.3759404780e-04 -5.9895751610e-04 -1051 1.0510000000e+01 -1.3159786030e-04 -5.9884024670e-04 -1052 1.0520000000e+01 -1.2562008510e-04 -5.9671537190e-04 -1053 1.0530000000e+01 -1.1971541890e-04 -5.8645497820e-04 -1054 1.0540000000e+01 -1.1391907460e-04 -5.7377073050e-04 -1055 1.0550000000e+01 -1.0824702940e-04 -5.6047034270e-04 -1056 1.0560000000e+01 -1.0269628380e-04 -5.4839149330e-04 -1057 1.0570000000e+01 -9.7245133280e-05 -5.3923980200e-04 -1058 1.0580000000e+01 -9.1853451120e-05 -5.3911449470e-04 -1059 1.0590000000e+01 -8.6462982460e-05 -5.3910199430e-04 -1060 1.0600000000e+01 -8.0997650220e-05 -5.5041729600e-04 -1061 1.0610000000e+01 -7.5368739520e-05 -5.7173059930e-04 -1062 1.0620000000e+01 -6.9499402950e-05 -5.9987988550e-04 -1063 1.0630000000e+01 -6.3348728690e-05 -6.3019444120e-04 -1064 1.0640000000e+01 -5.6916004900e-05 -6.5859860260e-04 -1065 1.0650000000e+01 -5.0240052900e-05 -6.8133908400e-04 -1066 1.0660000000e+01 -4.3398535910e-05 -6.8721567780e-04 -1067 1.0670000000e+01 -3.6507243520e-05 -6.8762860290e-04 -1068 1.0680000000e+01 -2.9719352220e-05 -6.7391683480e-04 -1069 1.0690000000e+01 -2.3224662110e-05 -6.3517303510e-04 -1070 1.0700000000e+01 -1.7248809950e-05 -5.7135297940e-04 -1071 1.0710000000e+01 -1.2043859570e-05 -4.8077252260e-04 -1072 1.0720000000e+01 -7.8448100750e-06 -3.6813962720e-04 -1073 1.0730000000e+01 -4.8270281820e-06 -2.4116727060e-04 -1074 1.0740000000e+01 -3.0987780870e-06 -1.0674709090e-04 -1075 1.0750000000e+01 -2.7024744570e-06 2.8614036460e-05 -1076 1.0760000000e+01 -3.6159753210e-06 1.5853729430e-04 -1077 1.0770000000e+01 -5.7539145360e-06 2.7678298170e-04 -1078 1.0780000000e+01 -8.9690733710e-06 3.7726806870e-04 -1079 1.0790000000e+01 -1.3053790830e-05 4.5374751230e-04 -1080 1.0800000000e+01 -1.7741412250e-05 4.9645783070e-04 -1081 1.0810000000e+01 -2.2717402080e-05 4.9635768930e-04 -1082 1.0820000000e+01 -2.7668550310e-05 4.9373434340e-04 -1083 1.0830000000e+01 -3.2330964780e-05 4.5092721080e-04 -1084 1.0840000000e+01 -3.6498647170e-05 3.9091840760e-04 -1085 1.0850000000e+01 -4.0022298200e-05 3.1893553480e-04 -1086 1.0860000000e+01 -4.2808089230e-05 2.4038641930e-04 -1087 1.0870000000e+01 -4.4816400650e-05 1.6059919060e-04 -1088 1.0880000000e+01 -4.6060527570e-05 8.4780110980e-05 -1089 1.0890000000e+01 -4.6605352970e-05 1.8223653080e-05 -1090 1.0900000000e+01 -4.6565988960e-05 -3.3314987920e-05 -1091 1.0910000000e+01 -4.6099238430e-05 -6.6873796480e-05 -1092 1.0920000000e+01 -4.5366824730e-05 -8.4916136160e-05 -1093 1.0930000000e+01 -4.4499679130e-05 -9.0355700370e-05 -1094 1.0940000000e+01 -4.3591609800e-05 -8.9952927120e-05 -1095 1.0950000000e+01 -4.2700237280e-05 -8.7651375340e-05 -1096 1.0960000000e+01 -4.1847951690e-05 -8.3360830850e-05 -1097 1.0970000000e+01 -4.1022891310e-05 -8.2903739490e-05 -1098 1.0980000000e+01 -4.0179942230e-05 -8.5063482370e-05 -1099 1.0990000000e+01 -3.9241758770e-05 -9.8313192120e-05 -1100 1.1000000000e+01 -3.8099804360e-05 -1.2447822810e-04 -1101 1.1010000000e+01 -3.6621345410e-05 -1.6534170470e-04 -1102 1.1020000000e+01 -3.4679816320e-05 -2.1818064580e-04 -1103 1.1030000000e+01 -3.2184148770e-05 -2.7819907000e-04 -1104 1.1040000000e+01 -2.9083598200e-05 -3.4125702240e-04 -1105 1.1050000000e+01 -2.5366519500e-05 -4.0351991940e-04 -1106 1.1060000000e+01 -2.1059118990e-05 -4.6127744400e-04 -1107 1.1070000000e+01 -1.6224183250e-05 -5.1095646380e-04 -1108 1.1080000000e+01 -1.0959784980e-05 -5.4915926570e-04 -1109 1.1090000000e+01 -5.3979664600e-06 -5.6732102600e-04 -1110 1.1100000000e+01 2.9659907510e-07 -5.6742631160e-04 -1111 1.1110000000e+01 5.9341452010e-06 -5.6066382740e-04 -1112 1.1120000000e+01 1.1331617930e-05 -5.2705013840e-04 -1113 1.1130000000e+01 1.6343217970e-05 -4.8102892890e-04 -1114 1.1140000000e+01 2.0865295550e-05 -4.2682936100e-04 -1115 1.1150000000e+01 2.4834928580e-05 -3.6840379250e-04 -1116 1.1160000000e+01 2.8228476910e-05 -3.0958860270e-04 -1117 1.1170000000e+01 3.1060112970e-05 -2.5407827860e-04 -1118 1.1180000000e+01 3.3380329340e-05 -2.0541192570e-04 -1119 1.1190000000e+01 3.5274423720e-05 -1.6718237570e-04 -1120 1.1200000000e+01 3.6860961690e-05 -1.4358272690e-04 -1121 1.1210000000e+01 3.8283995600e-05 -1.4050599770e-04 -1122 1.1220000000e+01 3.9680922010e-05 -1.4091331570e-04 -1123 1.1230000000e+01 4.1151837300e-05 -1.5145488130e-04 -1124 1.1240000000e+01 4.2754890750e-05 -1.6788298170e-04 -1125 1.1250000000e+01 4.4508020530e-05 -1.8405361040e-04 -1126 1.1260000000e+01 4.6390713930e-05 -1.9455426310e-04 -1127 1.1270000000e+01 4.8345791250e-05 -1.9485241340e-04 -1128 1.1280000000e+01 5.0281212820e-05 -1.9265493800e-04 -1129 1.1290000000e+01 5.2071908600e-05 -1.7208895670e-04 -1130 1.1300000000e+01 5.3561629730e-05 -1.3367792980e-04 -1131 1.1310000000e+01 5.4572080700e-05 -7.6096086180e-05 -1132 1.1320000000e+01 5.4940349260e-05 -3.4911970810e-06 -1133 1.1330000000e+01 5.4554256440e-05 7.7596661070e-05 -1134 1.1340000000e+01 5.3357134590e-05 1.6154909480e-04 -1135 1.1350000000e+01 5.1345125320e-05 2.4323900560e-04 -1136 1.1360000000e+01 4.8564445820e-05 3.1781175050e-04 -1137 1.1370000000e+01 4.5108624410e-05 3.8070237770e-04 -1138 1.1380000000e+01 4.1115706090e-05 4.2768998170e-04 -1139 1.1390000000e+01 3.6765429140e-05 4.4569996240e-04 -1140 1.1400000000e+01 3.2276373320e-05 4.4577483730e-04 -1141 1.1410000000e+01 2.7894657000e-05 4.3230431740e-04 -1142 1.1420000000e+01 2.3849973670e-05 3.8651116970e-04 -1143 1.1430000000e+01 2.0314535340e-05 3.2680232760e-04 -1144 1.1440000000e+01 1.7397851760e-05 2.5938783110e-04 -1145 1.1450000000e+01 1.5150232920e-05 1.8994220910e-04 -1146 1.1460000000e+01 1.3566325960e-05 1.2382271180e-04 -1147 1.1470000000e+01 1.2588685570e-05 6.6028107650e-05 -1148 1.1480000000e+01 1.2111376660e-05 2.1147970850e-05 -1149 1.1490000000e+01 1.1983608170e-05 -5.5445510610e-07 -1150 1.1500000000e+01 1.2013397080e-05 -6.3433927090e-07 -1151 1.1510000000e+01 1.1979618440e-05 6.9224805850e-06 -1152 1.1520000000e+01 1.1676213710e-05 4.4864949350e-05 -1153 1.1530000000e+01 1.0952841300e-05 9.4560562700e-05 -1154 1.1540000000e+01 9.7194851630e-06 1.5011734680e-04 -1155 1.1550000000e+01 7.9423493170e-06 2.0620127250e-04 -1156 1.1560000000e+01 5.6397197640e-06 2.5785045690e-04 -1157 1.1570000000e+01 2.8777951330e-06 3.0053260610e-04 -1158 1.1580000000e+01 -2.3351266940e-07 3.3028724980e-04 -1159 1.1590000000e+01 -3.5448065280e-06 3.3191037270e-04 -1160 1.1600000000e+01 -6.8714595930e-06 3.3193028550e-04 -1161 1.1610000000e+01 -1.0004797940e-05 3.0304498820e-04 -1162 1.1620000000e+01 -1.2749539600e-05 2.5408763700e-04 -1163 1.1630000000e+01 -1.4957470800e-05 1.9293355440e-04 -1164 1.1640000000e+01 -1.6530760420e-05 1.2458386860e-04 -1165 1.1650000000e+01 -1.7418004970e-05 5.3446519620e-05 -1166 1.1660000000e+01 -1.7610248450e-05 -1.6448088780e-05 -1167 1.1670000000e+01 -1.7136978150e-05 -8.1464308840e-05 -1168 1.1680000000e+01 -1.6062097780e-05 -1.3836894190e-04 -1169 1.1690000000e+01 -1.4479879090e-05 -1.8421787100e-04 -1170 1.1700000000e+01 -1.2510893210e-05 -2.1616290120e-04 -1171 1.1710000000e+01 -1.0294430290e-05 -2.3233687030e-04 -1172 1.1720000000e+01 -7.9678780230e-06 -2.3227402260e-04 -1173 1.1730000000e+01 -5.6486954130e-06 -2.3150892740e-04 -1174 1.1740000000e+01 -3.4322545090e-06 -2.1621802220e-04 -1175 1.1750000000e+01 -1.3934204810e-06 -1.9466108350e-04 -1176 1.1760000000e+01 4.1185956270e-07 -1.6850313820e-04 -1177 1.1770000000e+01 1.9449594820e-06 -1.3936779990e-04 -1178 1.1780000000e+01 3.1829692270e-06 -1.0873702930e-04 -1179 1.1790000000e+01 4.1170826780e-06 -7.7937096740e-05 -1180 1.1800000000e+01 4.7509787070e-06 -4.8134899120e-05 -1181 1.1810000000e+01 5.0991788260e-06 -2.0329557190e-05 -1182 1.1820000000e+01 5.1853377300e-06 4.6534024350e-06 -1183 1.1830000000e+01 5.0405482780e-06 2.6153287390e-05 -1184 1.1840000000e+01 4.7017245850e-06 4.3667703640e-05 -1185 1.1850000000e+01 4.2099998780e-06 5.6852853570e-05 -1186 1.1860000000e+01 3.6091206690e-06 6.5520030940e-05 -1187 1.1870000000e+01 2.9438377600e-06 6.8044387790e-05 -1188 1.1880000000e+01 2.2582945630e-06 6.8005776470e-05 -1189 1.1890000000e+01 1.5944132410e-06 6.5247449720e-05 -1190 1.1900000000e+01 9.9027914890e-07 5.7253374050e-05 -1191 1.1910000000e+01 4.7794482020e-07 4.6374107540e-05 -1192 1.1920000000e+01 7.9430367210e-08 3.3872879470e-05 -1193 1.1930000000e+01 -1.9586145530e-07 2.1091406450e-05 -1194 1.1940000000e+01 -3.5038203430e-07 9.1537875640e-06 -1195 1.1950000000e+01 -3.9696232700e-07 -9.8173844310e-07 -1196 1.1960000000e+01 -3.5733509120e-07 -8.5097413050e-06 -1197 1.1970000000e+01 -2.6065437280e-07 -1.1346751290e-05 -1198 1.1980000000e+01 -1.4201270800e-07 -1.1393547340e-05 -1199 1.1990000000e+01 -4.0956496040e-08 -8.7451546660e-06 -1200 1.2000000000e+01 0.0000000000e+00 -1.0906638080e-06 From 7d31544cc25c5dc43f20b776e0aff4ec44fc4a99 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 1 Jun 2022 15:04:28 -0400 Subject: [PATCH 276/585] simplify and avoid memory access and leak issues in parallel --- src/MANYBODY/pair_sw_angle_table.cpp | 53 +++++++++++++--------------- 1 file changed, 25 insertions(+), 28 deletions(-) diff --git a/src/MANYBODY/pair_sw_angle_table.cpp b/src/MANYBODY/pair_sw_angle_table.cpp index 5da277bc05..d66a959d52 100644 --- a/src/MANYBODY/pair_sw_angle_table.cpp +++ b/src/MANYBODY/pair_sw_angle_table.cpp @@ -219,10 +219,13 @@ void PairSWAngleTable::compute(int eflag, int vflag) void PairSWAngleTable::read_file(char *file) { - memory->sfree(params); - params = nullptr; - memory->sfree(table_params); - table_params = nullptr; + if (params) { + for (int m = 0; m < nparams; m++) free_param(&table_params[m]); // free_param will call free_table + memory->destroy(params); + memory->destroy(table_params); + memory->destroy(elem3param); + } + nparams = maxparam = 0; // open file on proc 0 @@ -285,22 +288,18 @@ void PairSWAngleTable::read_file(char *file) params[nparams].tol = values.next_double(); // read parameters of angle table - std::string tablename_string = values.next_string(); - table_params[nparams].tablenamelength = tablename_string.length()+1; - memory->create(table_params[nparams].tablename, table_params[nparams].tablenamelength, "table_params.tablename"); - for (int i = 0; i < table_params[nparams].tablenamelength; ++i) { - table_params[nparams].tablename[i] = tablename_string[i]; - } - std::string keyword_string = values.next_string(); - table_params[nparams].keywordlength = keyword_string.length()+1; - memory->create(table_params[nparams].keyword, table_params[nparams].keywordlength, "table_params.keyword"); - for (int i = 0; i < table_params[nparams].keywordlength; ++i) { - table_params[nparams].keyword[i] = keyword_string[i]; - } - auto tablestyle = values.next_string(); - if (tablestyle == "linear") table_params[nparams].tabstyle = LINEAR; - else if (tablestyle == "spline") table_params[nparams].tabstyle = SPLINE; - else error->all(FLERR,"Unknown table style {} of angle table file", tablestyle); + std::string name = values.next_string(); + table_params[nparams].tablenamelength = name.length()+1; + table_params[nparams].tablename = utils::strdup(name); + + name = values.next_string(); + table_params[nparams].keywordlength = name.length()+1; + table_params[nparams].keyword = utils::strdup(name); + + name = values.next_string(); + if (name == "linear") table_params[nparams].tabstyle = LINEAR; + else if (name == "spline") table_params[nparams].tabstyle = SPLINE; + else error->all(FLERR,"Unknown table style {} of angle table file", name); table_params[nparams].tablength = values.next_int(); } catch (TokenizerException &e) { @@ -333,13 +332,11 @@ void PairSWAngleTable::read_file(char *file) // for each set of parameters, broadcast table name and keyword and read angle table for (int m = 0; m < nparams; ++m){ if (comm->me != 0) { - memory->create(table_params[m].tablename, table_params[m].tablenamelength, "table_params.tablename"); + table_params[m].tablename = new char[table_params[m].tablenamelength]; + table_params[m].keyword = new char[table_params[m].keywordlength]; } - MPI_Bcast(&table_params[m].tablename, table_params[m].tablenamelength, MPI_CHAR, 0, world); - if (comm->me != 0) { - memory->create(table_params[m].keyword, table_params[m].keywordlength, "table_params.keyword"); - } - MPI_Bcast(&table_params[m].keyword, table_params[m].keywordlength, MPI_CHAR, 0, world); + MPI_Bcast(table_params[m].tablename, table_params[m].tablenamelength, MPI_CHAR, 0, world); + MPI_Bcast(table_params[m].keyword, table_params[m].keywordlength, MPI_CHAR, 0, world); // initialize angtable memory->create(table_params[m].angtable,1,"table_params:angtable"); @@ -618,8 +615,8 @@ void PairSWAngleTable::free_param(ParamTable *pm) // call free_table to destroy associated angle table free_table(pm->angtable); // then destroy associated angle table - memory->sfree(pm->keyword); - memory->sfree(pm->tablename); + delete[] pm->keyword; + delete[] pm->tablename; memory->sfree(pm->angtable); } From ea3467ab32d1a6edf775ea3778f6873c6922bc33 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Wed, 1 Jun 2022 13:19:47 -0600 Subject: [PATCH 277/585] benchmarking of replicated systems --- examples/amoeba/Compare.sh | 8 +- examples/amoeba/Test.sh | 8 +- examples/amoeba/amoeba_water_box.key | 2 +- examples/amoeba/dump.ubi.1 | 19492 ---------------------- examples/amoeba/dump.ubi.32 | 19492 ---------------------- examples/amoeba/in.ubiquitin | 2 +- examples/amoeba/log.ubi.1 | 162 - examples/amoeba/log.ubi.32 | 162 - examples/amoeba/log.water_box.amoeba.1 | 148 - examples/amoeba/log.water_box.amoeba.32 | 148 - examples/amoeba/log.water_box.hippo.1 | 152 - examples/amoeba/log.water_box.hippo.32 | 152 - tools/tinker/tinker2lmp.py | 210 +- 13 files changed, 218 insertions(+), 39920 deletions(-) delete mode 100644 examples/amoeba/dump.ubi.1 delete mode 100644 examples/amoeba/dump.ubi.32 delete mode 100644 examples/amoeba/log.ubi.1 delete mode 100644 examples/amoeba/log.ubi.32 delete mode 100644 examples/amoeba/log.water_box.amoeba.1 delete mode 100644 examples/amoeba/log.water_box.amoeba.32 delete mode 100644 examples/amoeba/log.water_box.hippo.1 delete mode 100644 examples/amoeba/log.water_box.hippo.32 diff --git a/examples/amoeba/Compare.sh b/examples/amoeba/Compare.sh index 8eaebcee30..fbe05275e0 100644 --- a/examples/amoeba/Compare.sh +++ b/examples/amoeba/Compare.sh @@ -44,9 +44,9 @@ kdiff.py dump.water_box.hippo.32 dump.water_box.hippo.32.test # ubiquitin -kdiff.py log.ubi.1 log.ubi.1.test -kdiff.py dump.ubi.1 dump.ubi.1.test +kdiff.py log.ubiquitin.1 log.ubiquitin.1.test +kdiff.py dump.ubiquitin.1 dump.ubiquitin.1.test -kdiff.py log.ubi.32 log.ubi.32.test -kdiff.py dump.ubi.32 dump.ubi.32.test +kdiff.py log.ubiquitin.32 log.ubiquitin.32.test +kdiff.py dump.ubiquitin.32 dump.ubiquitin.32.test diff --git a/examples/amoeba/Test.sh b/examples/amoeba/Test.sh index 68d81c8aef..a76e4edfc0 100644 --- a/examples/amoeba/Test.sh +++ b/examples/amoeba/Test.sh @@ -57,10 +57,10 @@ mv dump.water_box dump.water_box.hippo.32.test # ubiquitin ../../src/lmp_mpi < in.ubiquitin.test -mv log.lammps log.ubi.1.test -mv dump.ubi dump.ubi.1.test +mv log.lammps log.ubiquitin.1.test +mv dump.ubiquitin dump.ubiquitin.1.test mpirun -np 32 ../../src/lmp_mpi < in.ubiquitin.test -mv log.lammps log.ubi.32.test -mv dump.ubi dump.ubi.32.test +mv log.lammps log.ubiquitin.32.test +mv dump.ubiquitin dump.ubiquitin.32.test diff --git a/examples/amoeba/amoeba_water_box.key b/examples/amoeba/amoeba_water_box.key index 102be80d73..b74edf324a 100644 --- a/examples/amoeba/amoeba_water_box.key +++ b/examples/amoeba/amoeba_water_box.key @@ -6,7 +6,7 @@ openmp-threads 1 ewald ewald-alpha 0.4 pewald-alpha 0.5 -pme-grid 50 50 50 +pme-grid 24 24 24 neighbor-list a-axis 18.643 diff --git a/examples/amoeba/dump.ubi.1 b/examples/amoeba/dump.ubi.1 deleted file mode 100644 index 743c5e68dc..0000000000 --- a/examples/amoeba/dump.ubi.1 +++ /dev/null @@ -1,19492 +0,0 @@ -ITEM: TIMESTEP -0 -ITEM: NUMBER OF ATOMS -9737 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 5.4990000000000002e+01 -0.0000000000000000e+00 4.1909999999999997e+01 -0.0000000000000000e+00 4.1909999999999997e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 9.9631 5.60476 0.008413 6.29384 29.5246 19.0744 -2 2 9.59585 5.61686 40.5223 49.6095 -15.082 -19.7261 -3 2 8.19009 6.07902 40.3725 -38.3002 -36.0401 31.6494 -4 3 7.228 5.27674 40.5663 25.6537 34.3003 -15.2325 -5 4 9.24854 5.32486 0.671238 -4.4712 -3.37565 -7.28982 -6 4 10.3108 6.54317 0.309331 -11.8382 -28.5043 -8.77497 -7 4 10.7093 4.95217 0.170763 9.79439 -2.80927 4.02983 -8 4 10.3426 6.38567 40.0332 -19.5644 -29.2331 3.89265 -9 2 9.77742 4.13431 39.9813 -28.2245 -12.7597 2.79543 -10 2 9.48564 3.81758 38.4974 43.5672 -24.1926 -8.96475 -11 5 10.1176 2.11667 38.0047 -9.19737 11.9016 12.5734 -12 2 9.21456 1.10205 39.2112 31.2522 23.9396 11.6177 -13 4 8.99594 3.48122 40.5964 28.5446 19.8656 -13.413 -14 4 10.8136 3.75653 40.1807 -3.6049 4.77507 7.99264 -15 4 10.0744 4.47991 37.8007 -16.03 7.55553 14.4224 -16 4 8.42529 3.84402 38.2863 -20.8998 9.83371 -6.83213 -17 4 9.47601 1.46641 40.2263 -2.07893 -1.87234 0.341628 -18 4 9.53146 0.065851 39.1813 1.34892 -20.4385 -9.90461 -19 4 8.1577 1.22135 39.0727 -30.8502 -1.48556 -5.54631 -20 1 8.07565 7.408 40.3203 38.3461 4.68909 -14.5778 -21 2 6.84679 8.08521 40.1985 -59.0929 12.5985 8.76694 -22 2 6.18936 7.48414 38.9048 -11.7821 0.575019 41.3478 -23 3 6.7346 7.67531 37.8418 13.9355 0.826162 -41.115 -24 4 8.95137 7.92937 40.1018 -13.7432 5.12585 4.7357 -25 4 6.17099 7.78674 41.0889 17.7478 9.29385 -16.8634 -26 2 7.04543 9.68435 40.1788 6.06779 -36.4281 36.3417 -27 2 5.78315 10.5437 40.1541 10.0153 13.6856 -31.2349 -28 2 4.87823 10.4891 38.8981 8.0898 32.2503 -21.0798 -29 3 5.10035 11.2936 37.9551 -6.38068 -25.249 23.2549 -30 1 3.78765 9.69754 38.9447 7.74282 -10.5609 -2.0448 -31 4 7.77413 9.91905 39.4336 6.93206 10.4159 -38.5359 -32 4 7.65159 10.0279 41.0787 -15.5363 -12.6708 -2.68622 -33 4 6.21166 11.5927 40.0353 -14.0103 -9.11046 14.0038 -34 4 5.24199 10.4471 41.1154 -6.90019 6.03163 0.39253 -35 4 3.64982 9.13451 39.798 -8.63839 -3.4701 -4.98201 -36 4 3.18526 9.53497 38.0983 12.4509 11.2825 18.2671 -37 1 5.03649 6.76821 39.0271 29.2025 12.626 -49.9624 -38 2 4.1742 6.30537 37.9199 2.45922 -5.77224 11.4432 -39 2 2.7281 6.64357 38.2301 -33.27 13.9739 -28.2234 -40 3 2.48558 7.27851 39.247 -7.20167 1.94081 18.2399 -41 4 4.56901 6.92293 39.8729 -36.0812 -3.10094 47.9009 -42 4 4.41115 6.93099 37.0362 4.08063 -6.87028 -11.6053 -43 2 4.30896 4.77224 37.6863 5.60806 -34.2262 -10.7438 -44 2 3.61194 3.83713 38.7945 21.7291 41.8848 -7.6362 -45 2 5.81981 4.32753 37.5156 -0.302636 -10.5955 -12.2236 -46 2 3.74184 2.37563 38.4472 -21.3499 -20.7746 -35.862 -47 4 3.79188 4.51145 36.7016 6.3754 10.432 9.00978 -48 4 2.54774 4.08441 38.8361 -15.7139 1.18722 1.17999 -49 4 4.01487 4.13828 39.7949 0.987415 -11.5324 -1.87366 -50 4 6.38959 4.49596 38.46 -5.87199 -9.93517 1.91854 -51 4 6.36771 4.97617 36.7815 -14.8228 -10.6264 -0.132465 -52 4 5.90888 3.19548 37.1534 1.72477 39.701 11.5881 -53 4 3.39383 2.18531 37.3739 6.37275 7.50384 16.1992 -54 4 3.10231 1.69487 39.022 -2.76045 -1.11045 15.6564 -55 4 4.76015 2.00007 38.4839 16.883 -5.45935 8.37891 -56 1 1.68415 6.36719 37.3348 37.2769 -12.9922 15.6035 -57 2 0.304736 6.65563 37.6783 -19.186 -35.7743 -0.468083 -58 2 54.3638 5.41499 37.39 23.5408 9.01503 -19.9847 -59 3 54.8016 4.481 36.67 -18.0502 12.9096 17.6943 -60 4 1.81134 5.6821 36.5646 -2.38907 6.77101 2.69516 -61 4 0.26398 6.68603 38.7911 -5.02605 17.0245 3.77253 -62 2 54.6928 7.87629 36.9427 9.14228 37.5998 28.2049 -63 2 0.656467 9.08157 36.7109 -0.0956801 -8.96924 -14.639 -64 2 1.56488 9.23116 35.5658 -28.7887 -16.4207 21.28 -65 2 0.518242 10.1807 37.599 12.0453 -33.0617 -42.3022 -66 2 2.2549 10.4284 35.3456 -0.685553 9.51875 21.9154 -67 2 1.26608 11.2953 37.3573 -6.55985 56.8791 72.0683 -68 2 2.14201 11.4551 36.3269 43.9558 24.4422 -61.5967 -69 4 53.8494 8.28091 37.614 11.6877 -9.2043 -14.6276 -70 4 54.1796 7.56606 36.0251 1.84695 0.514683 -15.8045 -71 4 1.67027 8.40603 34.832 -2.56062 3.42592 3.08894 -72 4 54.8243 10.1788 38.4192 -16.1978 -2.83683 23.7337 -73 4 2.90465 10.5398 34.4584 1.04403 1.06161 3.93542 -74 4 1.2044 12.0958 38.199 3.2453 -15.1518 -32.2206 -75 4 2.76002 12.4636 36.1598 -24.4207 -43.5556 11.8549 -76 1 53.0705 5.5478 37.8043 -13.4682 25.7632 10.8407 -77 2 51.945 4.63101 37.5291 33.8243 -29.5042 -37.7332 -78 2 50.7838 5.44293 36.986 4.21111 -0.422475 -19.7833 -79 3 50.2621 6.29965 37.7355 -1.55474 -12.1519 -25.7528 -80 4 52.801 6.45436 38.3333 3.61532 -42.2821 -15.9338 -81 4 52.3053 3.83112 36.7028 -14.0928 30.7972 24.0178 -82 2 51.5456 3.79903 38.7793 9.75018 1.06621 4.26496 -83 2 50.3519 2.79661 38.4832 35.7171 10.1602 1.47909 -84 2 52.8174 3.02556 39.2171 -10.4567 -30.55 12.3487 -85 4 51.3202 4.51835 39.6193 -10.3559 -7.38818 -7.14654 -86 4 50.5612 2.13754 37.5331 -9.75373 16.6535 26.894 -87 4 49.4557 3.43665 38.3668 -10.8276 -7.01925 -6.76558 -88 4 50.2008 2.17632 39.4156 -2.83245 -1.1989 -13.0752 -89 4 53.3224 3.52205 40.064 3.32837 5.49303 2.41605 -90 4 53.5736 2.86114 38.4382 5.5955 2.25759 -8.48168 -91 4 52.5769 1.98664 39.5815 -0.855844 10.0945 -0.110617 -92 1 50.4393 5.19673 35.6351 -19.7264 9.67141 42.9571 -93 2 49.1691 5.71413 35.1171 8.57247 21.8964 -7.76629 -94 2 48.0882 4.65728 35.3507 -19.9883 30.8425 14.9148 -95 3 48.2827 3.53875 34.9335 -4.48089 -38.0316 -8.70437 -96 4 50.7426 4.33028 35.1784 2.31221 -1.81777 -1.86606 -97 4 48.9711 6.6281 35.7521 -11.2206 -0.672417 -16.6265 -98 2 49.2032 6.03091 33.5236 -0.851856 65.2811 26.1578 -99 2 47.9587 6.87959 32.9935 21.6676 -24.5773 11.3759 -100 2 48.0434 7.32811 31.5002 51.7858 -12.5586 -5.19204 -101 2 48.2074 6.22405 30.3724 28.294 -23.2516 17.4346 -102 1 48.1983 6.77555 28.9911 -71.9632 -28.6889 -6.605 -103 4 49.3393 5.11986 33.0139 -2.20502 -45.3575 -27.512 -104 4 50.0955 6.63289 33.1892 -0.645528 -4.64769 17.8413 -105 4 47.8013 7.74388 33.6913 1.36166 0.224784 -7.99748 -106 4 47.0904 6.22572 33.1496 -13.2574 -0.904539 -3.87726 -107 4 49.004 7.98659 31.3992 -27.9616 -9.11626 3.58403 -108 4 47.1978 7.96127 31.27 -20.0009 14.5444 -5.73856 -109 4 47.5417 5.33248 30.4619 -18.467 18.3391 -3.45282 -110 4 49.1897 5.66674 30.5732 -8.59668 22.4275 -14.4147 -111 4 48.9982 7.27964 28.7313 27.9214 19.6218 -9.55881 -112 4 47.3685 7.40493 28.8518 27.8731 -11.8414 7.77703 -113 4 48.0065 6.08598 28.2169 17.275 11.5652 28.2934 -114 1 46.9206 5.03778 35.9702 10.3577 18.9682 5.15831 -115 2 45.6557 4.25932 36.0398 9.08885 -0.641191 -14.1305 -116 2 44.8836 4.39003 34.674 17.924 -7.95306 73.8288 -117 3 45.3111 5.13887 33.8455 4.25406 24.8458 -47.415 -118 4 46.9247 5.98842 36.4259 -8.42518 -21.6093 -9.66 -119 4 45.9322 3.16772 36.074 -4.07513 2.77881 8.35057 -120 2 44.7235 4.66099 37.2497 -7.79148 27.6424 25.8282 -121 3 44.4559 6.1146 37.2032 37.085 -18.356 15.5747 -122 2 45.2448 4.26963 38.7181 22.7861 29.0575 -8.8559 -123 4 43.727 4.13168 37.1283 17.3832 10.5512 -0.864114 -124 4 45.2761 6.59903 37.5183 -34.0557 -21.4787 -11.7364 -125 4 45.8733 4.97275 39.4014 -10.271 -7.81482 -36.7347 -126 4 45.822 3.36133 38.5799 14.1835 -15.9263 3.29814 -127 4 44.4672 3.97387 39.4102 -27.3329 -5.40347 3.37723 -128 1 43.7561 3.68722 34.6039 -10.1769 -38.5504 10.0379 -129 2 42.7898 3.65331 33.5354 16.9998 -6.12306 -24.86 -130 2 41.7694 4.78815 33.7404 2.26966 -0.410412 -51.1213 -131 3 41.2522 5.37284 32.7445 13.6537 -18.3748 18.9894 -132 4 43.5295 2.98811 35.3697 5.99608 22.1557 -16.865 -133 4 43.3523 3.94914 32.5036 -19.5402 -19.5629 37.0771 -134 2 42.0755 2.18627 33.4863 21.9074 34.2086 -29.4327 -135 2 42.9391 0.859767 33.721 -6.85443 30.257 35.6042 -136 2 42.2358 41.4668 33.4285 -9.81834 -3.65893 -31.5778 -137 2 44.2283 0.854864 32.9471 53.2312 13.9788 40.9195 -138 4 41.6117 2.20331 32.4686 -4.39523 -13.2201 2.61812 -139 4 41.2586 2.27352 34.2121 -10.6776 -10.6054 4.67488 -140 4 43.2056 0.83773 34.8124 -0.343624 1.56324 -2.51079 -141 4 42.8118 40.5237 33.3983 6.69029 -0.569008 16.3673 -142 4 41.9597 41.5484 32.3684 -17.7546 -2.75522 -9.07631 -143 4 41.3245 41.3357 34.0216 -8.62626 -3.98831 3.9624 -144 4 44.0827 0.853311 31.8896 -3.53557 -4.02089 -36.565 -145 4 44.8236 41.822 33.2847 -5.06735 25.2561 -15.1823 -146 4 44.8583 1.80877 33.1923 -14.5958 -31.7921 -4.90526 -147 1 41.5264 5.19611 34.9737 -24.8334 44.6246 6.63495 -148 2 40.6685 6.33721 35.2699 -7.96634 19.3021 -16.1623 -149 2 41.3876 7.74941 35.097 -11.5591 -21.8484 1.81155 -150 3 40.7047 8.75309 34.8417 -6.4948 4.14558 0.128999 -151 4 41.7654 4.68652 35.8013 13.1043 -20.8107 18.8359 -152 4 39.8731 6.44712 34.4383 10.8594 -11.0445 14.3032 -153 2 39.8592 6.12601 36.6093 -15.5564 -7.24317 -37.5678 -154 3 40.7443 5.88444 37.6633 23.6025 16.5055 19.3857 -155 2 38.9047 4.85477 36.5395 -12.0583 61.1722 12.675 -156 4 39.322 7.07341 36.7706 -11.99 4.52079 9.89046 -157 4 41.1265 6.74598 37.8781 -3.93551 -10.4676 -4.79928 -158 4 38.0585 4.98564 35.7954 18.0693 -6.53498 -0.435941 -159 4 38.3566 4.77654 37.5171 8.14363 -6.92414 -3.72239 -160 4 39.543 3.99696 36.3828 0.165947 -30.6128 -6.86199 -161 1 42.7342 7.80416 35.136 -13.9315 11.8694 11.7976 -162 2 43.5142 9.02936 34.9481 17.7181 -46.9691 35.2138 -163 2 44.5073 9.42999 36.0349 -55.8537 -50.7646 50.0035 -164 3 45.375 10.2125 35.7599 43.422 25.9365 -4.74067 -165 4 43.1984 6.94617 35.4338 19.599 0.647333 4.29925 -166 4 44.1406 8.86955 34.0842 9.16679 3.97336 -28.1373 -167 4 42.9197 9.91228 34.8204 -18.5221 19.1219 -12.9063 -168 1 44.2798 8.93745 37.3587 -4.0043 10.1489 -58.0949 -169 2 45.1948 9.27519 38.4238 -4.17993 36.3676 -26.0855 -170 2 46.5575 8.73344 38.0061 12.5522 -20.4469 18.6928 -171 3 46.7331 7.49794 37.7681 -6.88831 31.8582 -6.20611 -172 4 43.377 8.45873 37.5311 9.37776 2.67644 11.4724 -173 4 45.2318 10.4158 38.3238 5.33405 -13.6354 14.6161 -174 2 44.7823 8.84756 39.8415 35.39 -32.4267 -9.44324 -175 2 45.5211 9.64049 40.9405 -33.0234 -16.4934 27.578 -176 2 45.0293 11.1067 41.0295 26.955 13.1382 1.75579 -177 2 45.9939 11.883 0.056845 5.44769 -3.52142 -7.77113 -178 1 45.567 13.2463 0.389189 -21.8942 22.5552 58.7427 -179 4 44.9649 7.71121 39.9163 -1.68078 22.7299 4.94117 -180 4 43.7292 8.96914 40.0006 -34.3585 3.91778 0.788359 -181 4 46.6326 9.56148 40.8729 -4.12637 -0.755434 -1.7729 -182 4 45.1589 9.15652 0.052119 21.5355 9.01144 -26.2886 -183 4 44.0384 11.1525 41.4882 -17.6691 -1.8484 1.78047 -184 4 44.9645 11.6456 40.0488 1.32443 -5.52779 3.51863 -185 4 46.9936 12.0079 41.4163 -11.0521 -7.71607 17.8496 -186 4 46.0863 11.2417 1.01939 6.64185 25.7549 -16.0759 -187 4 45.6176 13.9315 41.5535 6.39074 -1.54943 -2.93714 -188 4 46.1207 13.6426 1.21669 -15.3499 -18.2055 -38.2327 -189 4 44.572 13.3465 0.725918 28.6554 -12.4083 -12.8179 -190 1 47.5723 9.62675 38.0225 1.62241 16.525 -13.2778 -191 2 48.9413 9.31976 37.6447 28.3505 6.17866 3.85392 -192 2 49.7947 9.65595 38.897 -51.2415 76.6103 -24.0977 -193 3 49.6063 10.7902 39.4401 12.9093 -42.4425 -12.577 -194 4 47.4538 10.6389 38.3066 -1.81401 -22.4625 -4.08398 -195 4 49.0905 8.23756 37.4201 -8.03606 -0.867672 -0.903629 -196 2 49.3577 10.1392 36.3514 -15.5639 -8.86216 -34.5575 -197 3 48.3381 9.84531 35.2995 20.2521 4.60838 26.9691 -198 2 50.6821 9.73379 35.6575 -13.1705 -1.52152 26.2758 -199 4 49.443 11.2403 36.5183 -14.2645 -0.263993 8.70321 -200 4 47.5106 10.2398 35.5579 0.218555 2.62212 3.26783 -201 4 50.9323 10.3465 34.7687 -2.88514 -3.55444 -7.60949 -202 4 50.7732 8.65192 35.4951 -3.14548 -9.24106 -12.1943 -203 4 51.4763 9.94768 36.3674 17.1427 5.0591 10.0517 -204 1 50.5022 8.69828 39.4305 24.0939 -43.466 77.1583 -205 2 51.0483 8.71922 40.8082 -0.802123 10.2433 -32.8315 -206 2 52.5183 8.33859 40.7231 46.1376 25.1574 58.8821 -207 3 52.8914 7.33748 40.1143 13.0446 10.4001 -14.6089 -208 4 50.6189 7.73433 39.1341 -5.48208 -8.91176 -29.3848 -209 4 51.0045 9.75097 41.1725 -0.547397 17.2241 4.09797 -210 2 50.2922 7.85282 41.8455 19.6626 -50.7873 -7.63422 -211 2 50.2811 6.29504 41.471 -17.2864 -17.6708 26.7503 -212 2 48.8668 8.31684 0.212195 -17.3783 63.506 12.4232 -213 2 49.3691 5.38294 0.512646 14.3884 65.6628 -4.02696 -214 4 50.9326 7.9114 0.860642 -12.3241 5.1929 3.57402 -215 4 51.3127 5.83882 41.5287 -4.74499 10.5855 -5.5164 -216 4 49.8921 6.13652 40.4532 1.6457 0.843055 -11.9856 -217 4 48.0317 8.06123 41.424 13.0217 -7.20036 -2.54126 -218 4 48.8693 9.49201 0.254246 -0.917701 -32.4673 -2.46528 -219 4 48.5263 8.05212 1.23597 1.41612 -6.96817 -0.649274 -220 4 48.2816 5.57755 0.309314 6.34191 -1.32326 5.14384 -221 4 49.6363 5.72968 1.56057 -11.1106 -15.1353 -5.99489 -222 4 49.54 4.32324 0.397743 7.27301 -24.1582 -2.3836 -223 1 53.3925 9.14738 41.5454 -19.7766 -15.6836 -47.6014 -224 2 54.8543 9.29866 41.641 -12.5045 -20.0873 29.727 -225 2 0.407838 8.25913 0.762984 -29.7207 32.5524 -37.8245 -226 3 54.8643 8.2564 1.86493 17.0269 -29.0845 20.332 -227 4 52.9285 9.69819 0.341812 -9.11605 14.2566 13.2302 -228 4 0.291486 9.0623 40.6877 9.99865 -5.39191 -34.8298 -229 2 0.359683 10.7121 0.203065 -6.90664 -3.88067 -14.6485 -230 3 54.4765 11.8025 41.752 -11.2022 -21.2627 -5.88002 -231 2 1.6614 11.1001 41.4135 2.5167 -27.9916 -13.3179 -232 4 0.487415 10.6137 1.28953 0.410521 18.1219 13.0764 -233 4 54.0953 12.1937 0.613553 1.59003 1.59721 11.7532 -234 4 1.92456 12.0955 41.7398 14.8193 23.7252 4.53742 -235 4 1.52762 11.126 40.2979 3.61624 1.93597 7.36374 -236 4 2.5241 10.4069 41.6364 -8.38015 7.04993 1.52106 -237 1 1.45864 7.53391 0.367476 0.545631 9.71791 -21.8799 -238 2 2.25081 6.65311 1.15507 26.446 -0.0641839 -18.4938 -239 2 3.7671 6.96757 0.917085 -57.4365 -22.4689 85.9929 -240 3 4.15047 7.41488 41.7757 21.4144 12.1214 -29.7802 -241 4 1.8001 7.62601 41.3064 3.76941 -0.348546 3.21752 -242 4 1.98413 6.84865 2.19976 1.77378 -4.57114 13.3572 -243 2 1.98593 5.20856 0.673411 -39.0557 8.05152 -2.47083 -244 2 0.499001 4.77546 0.950638 51.92 -35.3278 3.54994 -245 2 0.302449 3.38226 0.307039 12.2804 5.92691 27.6936 -246 2 0.318833 4.59091 2.46762 -57.1886 17.9845 23.4913 -247 4 2.62035 4.47984 1.15306 24.0478 -12.5257 10.4353 -248 4 2.17019 5.14075 41.4887 6.74012 -0.473312 -2.7006 -249 4 54.8482 5.46061 0.448133 -33.0903 28.7369 -7.07308 -250 4 54.2241 3.15851 0.337643 -14.6094 -12.7265 -2.24176 -251 4 0.881511 2.58656 0.876485 -8.96903 11.0382 -11.5819 -252 4 0.635114 3.38296 41.1822 2.70741 -4.49002 -20.1461 -253 4 0.991181 3.80938 2.86091 2.53728 -4.51346 7.06316 -254 4 54.1796 4.30541 2.72425 38.6722 3.44969 -10.622 -255 4 0.495432 5.52724 3.08531 2.73328 -11.7655 -13.2166 -256 1 4.49387 6.66874 2.05101 59.25 35.5651 -63.8633 -257 2 5.97745 6.82619 2.08157 -13.5783 -40.6566 -15.6714 -258 2 6.57448 5.47381 2.54294 67.6927 12.9151 50.3283 -259 3 7.53922 5.43765 3.33186 -5.78511 6.85237 -12.8739 -260 4 4.10191 6.33546 2.9164 -11.2688 -10.0369 11.6191 -261 4 6.35409 6.85375 1.02753 1.73229 12.3732 3.55997 -262 2 6.47001 8.00523 2.96248 -35.1701 -2.47648 -9.01657 -263 2 6.52316 9.38515 2.26526 -52.089 -36.3571 -52.5381 -264 2 6.66039 10.5311 3.17647 23.2175 30.5211 32.7092 -265 3 7.81872 10.9467 3.49478 5.10838 -9.19539 -6.96115 -266 3 5.64173 11.0573 3.6767 -20.5888 -1.64097 0.158765 -267 4 7.42654 7.87231 3.41702 35.4584 -16.2138 5.63399 -268 4 5.81838 7.86205 3.84167 -4.54492 27.3919 10.2645 -269 4 5.56237 9.49095 1.59664 20.5708 1.89307 25.306 -270 4 7.29681 9.38215 1.47849 13.2355 1.21078 1.19218 -271 1 6.08096 4.31767 2.17259 -39.414 -15.8224 -24.7678 -272 2 6.39518 2.91476 2.36043 4.12081 37.0723 19.1814 -273 2 7.75633 2.62628 1.79624 63.8838 -9.4865 -25.3011 -274 3 8.33634 3.36937 0.946953 -27.4154 -16.213 26.3787 -275 4 5.28658 4.43126 1.58002 -24.0887 -1.16266 -20.2566 -276 4 6.54455 2.77577 3.45017 -8.86613 -5.70482 8.60941 -277 2 5.25427 2.02933 1.82805 -30.6144 -48.6247 5.61864 -278 2 3.85552 2.1153 2.66383 78.486 27.413 32.1434 -279 2 4.87851 2.27508 0.297641 -10.4566 -15.7718 22.2154 -280 4 5.65998 0.937168 1.99721 -15.6319 23.5495 -14.0675 -281 4 3.98898 1.63213 3.72107 -1.04911 23.3354 -24.3429 -282 4 3.15409 1.48884 2.20213 -45.477 -24.0418 -26.2275 -283 4 3.51802 3.20813 2.70746 -2.40249 -20.6527 6.6832 -284 4 4.39172 3.24426 0.119355 -1.44384 9.21297 0.0772101 -285 4 4.19746 1.51559 41.6955 12.4172 8.09212 16.5491 -286 4 5.82002 2.28129 41.6778 17.5327 1.3005 -22.4945 -287 1 8.43941 1.53208 2.30673 1.7292 42.4201 -39.4356 -288 2 9.76672 1.10452 1.81012 11.995 -19.5667 23.3003 -289 2 9.60964 41.7637 0.921245 4.05677 21.7498 -11.1929 -290 3 8.59567 41.087 1.06007 7.18507 -15.5872 -8.58634 -291 4 7.90606 0.81761 2.76924 -8.42032 -19.931 16.3865 -292 4 10.4026 1.87877 1.34085 -18.5158 15.1062 -12.7744 -293 2 10.6232 0.647963 3.0246 -34.7832 -39.5023 14.4787 -294 2 11.0993 1.6812 4.04079 16.2934 16.5377 23.708 -295 2 12.4719 2.27616 3.59128 -46.8378 -2.52013 6.7155 -296 3 13.4675 1.63575 4.02276 22.0629 14.477 -13.463 -297 3 12.4471 3.24187 2.73298 15.8946 -22.2661 28.0778 -298 4 11.4641 0.045385 2.63277 10.8271 5.92943 5.75519 -299 4 10.0353 41.7446 3.607 8.35649 20.5438 -12.0897 -300 4 11.2832 1.11765 5.0427 -4.51453 13.9694 -21.6118 -301 4 10.341 2.4932 4.3105 9.65416 -13.2167 -8.7997 -302 1 10.6494 41.4676 0.039711 8.78515 0.440053 18.9323 -303 2 10.7217 40.2184 41.1909 10.2574 -28.5822 12.1248 -304 2 10.6889 38.8907 0.171469 -17.3791 70.2346 -13.2363 -305 3 10.1368 37.8928 41.652 0.864281 -20.5458 12.6113 -306 4 9.82473 40.2067 40.5786 -14.2689 -8.84554 -18.4029 -307 2 12.0478 40.1799 40.3262 -31.3786 20.6535 10.6233 -308 2 12.4388 41.6551 40.4794 16.223 20.8678 -10.392 -309 2 11.8805 0.34241 41.7792 -28.1233 -36.7072 -34.4959 -310 4 11.9102 39.8982 39.2292 -1.08614 0.893428 17.4874 -311 4 12.7409 39.4563 40.8087 9.93344 3.46544 -3.32375 -312 4 12.0845 0.391154 39.5895 8.62314 -16.2997 14.2071 -313 4 13.5502 41.7447 40.5643 -1.70925 0.910467 -12.4735 -314 4 11.7305 1.40344 41.6414 -9.5626 24.5309 -2.35213 -315 4 12.5687 0.26268 0.684216 19.8182 -9.73862 27.9097 -316 1 11.1854 39.0885 1.40191 34.1901 -11.3327 18.3686 -317 2 11.4785 38.09 2.41707 -37.5808 13.2867 4.32174 -318 2 10.2405 37.7763 3.3402 -0.155099 -13.1844 6.87934 -319 3 10.4378 36.9653 4.27207 -11.6928 9.67513 -22.7546 -320 4 11.6756 39.9703 1.62918 -8.97807 -2.58442 -2.36164 -321 4 11.7153 37.147 1.89269 -3.37493 -11.1801 -2.58831 -322 2 12.7263 38.4682 3.25859 -32.7454 -15.529 27.3397 -323 3 12.5885 39.7408 3.87129 1.54426 18.5893 -11.5354 -324 4 13.5945 38.4441 2.61946 23.9879 5.88222 -14.7576 -325 4 12.9197 37.685 4.04183 -3.566 10.9198 -2.82194 -326 4 11.9285 39.8531 4.57214 8.5625 -16.1459 -5.7164 -327 1 8.98961 38.3717 3.14779 19.3135 28.1448 -76.0315 -328 2 7.78009 38.1002 3.90315 -4.26896 22.0341 0.229441 -329 2 6.83069 37.1869 3.18241 -25.8564 -25.3069 -16.1867 -330 3 6.84398 36.9785 1.97125 20.9058 23.903 -13.4458 -331 4 8.79049 38.9506 2.20714 10.5577 -30.8167 54.9659 -332 4 8.11274 37.5073 4.75427 1.14536 -6.32615 23.8911 -333 2 7.0077 39.4163 4.32571 4.21253 -4.87986 18.678 -334 2 7.75781 40.1168 5.42156 46.58 -14.1846 12.934 -335 3 8.30143 41.2262 5.21331 -14.6188 11.6514 -5.86083 -336 3 8.10545 39.4797 6.46784 -18.045 3.20128 -4.6129 -337 4 6.01572 39.173 4.78754 -1.72287 0.045533 -10.2864 -338 4 6.87032 40.2048 3.55457 -4.98407 -10.6589 -12.5629 -339 1 5.91154 36.4899 3.88964 18.6928 -0.691686 25.3425 -340 2 4.98537 35.571 3.20749 -24.0931 31.8814 30.8723 -341 2 3.79198 36.4499 2.67545 58.5623 50.3783 54.6165 -342 3 3.60244 37.6478 3.05835 4.98938 -42.2114 -12.2812 -343 4 5.945 36.5545 4.93654 -10.5756 -4.83423 -16.3239 -344 4 5.5221 35.038 2.40161 -3.05594 2.46612 -11.4716 -345 2 4.40384 34.4728 4.15145 -1.70261 45.9252 5.92389 -346 3 3.98498 35.0725 5.41787 -8.00202 -46.5665 -16.5053 -347 2 5.48475 33.4747 4.46048 0.249803 -29.9924 71.6177 -348 4 3.54337 34.0389 3.61058 -6.82183 -12.9435 7.69028 -349 4 3.62675 34.2747 5.86698 6.39679 27.749 2.05336 -350 4 5.85279 32.9868 3.57629 11.3184 -16.9973 -22.3871 -351 4 5.09248 32.6743 5.23041 8.97186 17.4623 -32.7541 -352 4 6.34746 33.9006 5.03324 -0.476546 4.78606 -11.5797 -353 1 3.00152 35.8184 1.87366 -46.1462 -42.5584 -55.0681 -354 2 1.77021 36.3468 1.35692 -36.7765 14.163 11.1031 -355 2 0.721356 36.5788 2.57059 18.2386 -29.7925 23.2574 -356 3 54.9678 37.5551 2.63992 10.9193 3.0322 -8.68025 -357 4 3.31287 34.9586 1.40066 1.19836 -3.77239 4.28893 -358 4 2.05059 37.3327 0.922928 -11.4048 10.7741 9.22697 -359 2 1.07197 35.5705 0.158527 41.3495 -39.9506 -9.05678 -360 2 1.73776 35.9497 40.6674 -26.4234 39.8053 33.0301 -361 2 54.5322 35.7209 0.133627 -14.8072 -12.0564 -1.20894 -362 2 3.23928 35.9487 40.63 7.11928 -24.1756 -12.68 -363 4 1.32474 34.4514 0.269568 -7.211 20.0201 5.35532 -364 4 1.47926 37.0502 40.6385 -3.87579 -7.90549 -26.2729 -365 4 1.36122 35.3789 39.7771 -4.72819 3.84386 12.155 -366 4 54.087 35.0558 41.2526 3.68912 7.63158 3.17282 -367 4 54.2076 36.7772 41.8385 0.949253 -6.55132 4.09096 -368 4 54.0676 35.3362 1.10912 4.22691 12.456 -17.368 -369 4 3.57003 34.9443 40.8434 9.13412 -24.8126 8.40569 -370 4 3.78301 36.5792 41.3142 5.34684 18.5101 18.1918 -371 4 3.6567 36.127 39.6372 -0.20476 7.44967 -14.9904 -372 1 0.712989 35.6055 3.58431 38.0557 9.26554 -59.6495 -373 2 0.05279 35.6483 4.83915 -15.0961 2.42646 38.658 -374 2 0.191347 37.0144 5.48801 7.00468 33.8104 1.40802 -375 3 54.154 37.7008 5.76148 35.4113 -11.6645 -8.2681 -376 4 1.23482 34.733 3.35856 -11.2418 4.01634 10.8504 -377 4 53.9671 35.581 4.69172 -20.2496 -5.13772 -12.456 -378 2 0.463881 34.4895 5.81355 17.031 15.9659 -33.5139 -379 2 54.8083 34.3393 7.16558 -30.7527 -16.2072 -11.1445 -380 2 0.00712 35.4957 8.10271 3.59003 -8.69902 15.3198 -381 3 54.0967 36.3529 8.34542 -1.77732 -9.94333 -12.6544 -382 3 1.07192 35.4587 8.7399 35.3598 16.353 18.5034 -383 4 1.56574 34.5304 5.94519 0.590681 0.639559 4.32925 -384 4 0.280894 33.5741 5.23349 -1.52963 -16.3279 0.16603 -385 4 0.223173 33.3947 7.64873 -6.8885 8.42796 -3.46601 -386 4 53.7112 34.1554 6.97481 9.65493 -2.46487 7.60139 -387 1 1.50649 37.4152 5.65526 -22.458 -31.2308 -17.0045 -388 2 2.02438 38.6379 6.15097 -3.22056 29.1656 36.4104 -389 2 1.58588 39.8651 5.40701 -13.5031 20.9194 -76.104 -390 3 1.07209 40.8553 5.93778 8.03965 -15.1327 11.1864 -391 4 2.24702 36.741 5.38136 -6.00826 1.88497 2.51587 -392 4 1.72629 38.833 7.20228 -22.1923 -11.9073 0.0585309 -393 2 3.51949 38.6121 6.24971 43.6984 -50.5664 -0.0787057 -394 2 4.11017 39.7004 7.10642 -5.48661 12.2779 -12.8977 -395 3 4.55887 40.7033 6.57435 6.12607 11.2234 -5.55098 -396 1 3.97545 39.5562 8.42942 -13.6958 7.00999 41.6346 -397 4 3.92653 38.5973 5.19958 6.67843 9.43594 11.2804 -398 4 3.90699 37.6191 6.72902 -10.8805 23.4385 -12.7616 -399 4 3.35162 38.8096 8.83526 13.2612 9.60447 -6.60232 -400 4 4.25023 40.3377 9.09595 -2.56729 -20.1743 -21.9158 -401 1 1.64621 39.8034 3.99517 -50.1719 52.4074 67.8966 -402 2 0.960547 40.8538 3.14427 -3.37695 -31.9032 -17.009 -403 2 54.4047 41.0035 3.47138 71.1401 19.2662 2.3079 -404 3 53.9887 0.221409 3.63964 -22.8765 18.4333 9.81455 -405 4 2.07659 38.9926 3.63308 18.9969 -31.9912 -34.7926 -406 4 1.39808 41.8727 3.34889 0.835518 -9.01277 1.27119 -407 2 1.14841 40.4887 1.56595 -9.49555 20.2148 39.7014 -408 2 0.469253 41.6189 0.677094 10.8075 11.2475 47.495 -409 2 2.6528 40.4777 1.25625 -15.459 -47.3647 -39.6369 -410 4 0.776571 39.4398 1.40308 -11.1955 11.1351 -6.38222 -411 4 54.3852 41.8501 0.825468 -5.0709 -17.7069 -2.05205 -412 4 0.696071 41.5065 41.5456 0.0730393 -4.82529 -32.9133 -413 4 0.904174 0.691668 0.985463 6.30616 -9.41897 -5.2369 -414 4 2.64269 40.3122 0.13166 16.7998 18.1471 15.5753 -415 4 3.13789 39.5289 1.58622 -1.56816 4.1145 9.56394 -416 4 3.29805 41.2779 1.59825 6.1243 20.9887 1.16769 -417 1 53.684 39.9214 3.65257 -36.1976 13.6917 8.19643 -418 2 52.3006 39.9493 4.06589 -56.8626 -17.5359 -10.0305 -419 2 52.042 40.5256 5.46425 9.62461 10.2848 -5.14962 -420 3 51.0331 41.2228 5.70144 14.4944 -11.372 -4.23176 -421 4 54.0189 39.0607 3.30247 15.8062 -40.5534 -6.95561 -422 4 51.6931 40.6476 3.38276 19.0563 -8.07776 7.22418 -423 2 51.5622 38.4976 3.96193 14.5706 2.1127 21.5154 -424 2 51.4158 37.9814 2.50572 24.752 -20.928 -15.9835 -425 2 51.0077 36.4305 2.37064 11.3099 30.9145 9.08043 -426 2 50.8522 35.9939 0.907307 -46.4939 -7.09254 -49.7464 -427 1 50.1475 34.7025 0.671588 69.6077 -32.405 2.84717 -428 4 50.6006 38.4842 4.55016 3.73478 6.81079 -18.2086 -429 4 52.1831 37.7463 4.55262 -3.81101 12.3643 -13.1539 -430 4 52.4118 38.1657 2.02278 1.77015 -18.5404 7.48984 -431 4 50.8584 38.5927 1.79489 -26.3581 9.74254 8.34414 -432 4 50.0453 36.2246 2.88499 -2.56193 3.57961 3.68626 -433 4 51.7703 35.8375 2.92238 0.215708 -6.73604 -5.33103 -434 4 51.7691 36.0437 0.240386 -6.2594 -4.10885 19.6388 -435 4 50.1039 36.686 0.3716 22.9763 1.60597 16.3794 -436 4 50.5914 33.8993 1.10828 2.95648 12.8391 18.7814 -437 4 50.3001 34.3737 41.6268 -19.3387 19.3411 -4.27099 -438 4 49.2006 34.6111 0.961468 -24.084 7.88088 -0.582308 -439 1 53.0235 40.2561 6.35237 -32.3128 10.4579 -5.0201 -440 2 53.1129 40.7256 7.70074 -41.6363 -1.15369 57.3167 -441 2 53.1798 0.352689 7.77253 -34.9991 -20.8035 37.2736 -442 3 52.5119 1.01286 8.63006 21.7579 -17.6925 -30.8538 -443 4 53.6931 39.5673 6.06584 22.7894 -18.2937 1.39271 -444 4 52.0865 40.4844 8.3065 35.7608 3.68212 -29.1988 -445 2 54.2701 40.0034 8.46069 6.08948 28.5921 -6.02695 -446 4 54.5971 40.5153 9.39975 -22.234 -14.34 10.1754 -447 4 0.201561 40.2092 7.93116 13.6903 -2.08726 -21.3806 -448 4 54.1655 38.8939 8.41526 -0.559105 0.118215 15.5404 -449 1 53.9752 0.884949 6.87383 32.3465 35.364 -24.1241 -450 2 54.062 2.35993 6.75215 -1.13821 -0.709889 -34.8218 -451 2 52.7471 3.02097 6.14186 4.92946 35.4069 59.7439 -452 3 52.3227 4.16587 6.4978 18.9545 -33.4145 3.00952 -453 4 54.7345 0.266534 6.4753 -18.8262 24.4346 -1.05702 -454 4 54.2802 2.76759 7.79054 -12.1814 3.84369 -14.3249 -455 2 0.185451 2.81859 5.73187 27.2059 46.9588 30.4236 -456 2 1.71808 2.36893 6.1571 -63.9259 -20.0653 -29.4315 -457 2 1.9764 2.63004 7.63437 43.6306 13.7343 2.97159 -458 2 3.27263 1.81187 8.04275 -33.9139 -3.58936 -6.58926 -459 1 3.78328 2.11956 9.34176 26.6398 21.4152 24.507 -460 4 0.173809 4.01773 5.82442 4.54198 -39.0295 -6.50933 -461 4 54.8792 2.64498 4.65574 11.0791 -10.5686 10.592 -462 4 2.43618 2.90609 5.45978 -2.35628 -10.1976 10.4282 -463 4 1.76796 1.2289 6.01344 4.57023 21.5888 -8.89179 -464 4 1.21473 2.41369 8.37281 -19.449 -19.8593 5.28327 -465 4 2.02309 3.72579 7.75906 18.9296 5.96095 -1.30777 -466 4 4.11389 1.88412 7.33652 2.51142 0.584915 -8.00636 -467 4 2.91513 0.727469 8.06593 14.1612 11.4678 0.952909 -468 4 3.87966 1.33238 9.93849 2.65093 -23.7146 9.43734 -469 4 3.29203 2.7681 9.89323 -42.3935 13.6729 9.41431 -470 4 4.65765 2.6209 9.4154 12.4458 -11.5538 -21.8273 -471 1 52.0387 2.32512 5.28273 -51.3661 -11.8477 -11.6622 -472 2 50.6641 2.72274 4.84157 25.7857 6.93126 13.1254 -473 2 49.5414 2.57609 5.91007 27.6149 -7.37739 5.45836 -474 3 48.7805 3.52104 6.09585 -8.9672 -1.93713 4.87304 -475 4 52.4681 1.55108 4.79165 6.19099 -18.5603 -5.58783 -476 4 50.6769 3.82983 4.70864 1.41274 -1.50214 -10.3294 -477 2 50.3587 2.05695 3.49156 -22.4167 -18.5545 -8.10533 -478 2 51.392 2.35646 2.3419 -24.5199 12.8001 2.40788 -479 2 48.9327 2.41504 2.97856 -9.14079 -2.86031 26.3031 -480 2 51.1945 1.4129 1.15651 29.522 -13.6455 -15.5517 -481 4 50.3189 0.937191 3.7523 9.08136 15.4094 -11.3523 -482 4 52.3823 2.12188 2.68097 31.5971 -0.36407 15.4796 -483 4 51.4014 3.46798 2.06765 -1.078 -19.9026 -0.0406259 -484 4 48.2117 2.12758 3.78451 -1.04241 22.2186 2.00084 -485 4 48.5813 1.67256 2.28636 2.21501 -12.0529 -35.8697 -486 4 48.7327 3.44552 2.54328 5.48386 -12.5705 11.3103 -487 4 52.1623 1.3706 0.452926 -36.5132 5.61179 20.4585 -488 4 50.2881 1.70969 0.600596 -1.11419 -0.409473 -10.6314 -489 4 51.0211 0.353877 1.53511 3.53067 13.7442 -8.50616 -490 1 49.5623 1.51743 6.77214 29.0905 -0.0770965 -25.5222 -491 2 48.7084 1.41716 7.91723 -3.12505 -21.6463 4.96918 -492 2 48.8549 2.61932 8.82546 31.903 20.2748 29.0475 -493 3 47.906 3.05048 9.46897 -16.8524 2.35798 -10.3438 -494 4 50.2118 0.710522 6.59294 -12.9921 18.0739 4.61122 -495 4 47.6425 1.393 7.52359 9.91609 0.328738 10.372 -496 2 49.0787 0.089334 8.73016 -60.0302 -9.6098 -44.8862 -497 2 48.2852 41.7441 10.0242 3.18066 15.7764 -9.96769 -498 2 46.7826 0.060746 9.96682 -2.34726 -14.6607 41.7592 -499 3 46.2233 0.511631 10.9878 -5.96974 4.10403 -23.4495 -500 1 46.1388 41.3329 8.97776 32.9533 20.065 15.0282 -501 4 50.1182 0.035639 8.93296 42.8084 2.68407 12.3764 -502 4 48.8904 41.1121 8.0025 3.88899 17.9501 19.4277 -503 4 48.6104 0.602172 10.7954 4.73737 -18.8132 -0.914642 -504 4 48.4759 40.6816 10.3394 0.165969 9.19265 10.3013 -505 4 46.673 40.8953 8.25882 14.2049 -15.3063 -26.5369 -506 4 45.1569 41.364 8.91958 -49.0994 -2.53611 0.320683 -507 1 50.1114 3.13932 9.06291 -28.12 32.8195 0.337886 -508 2 50.3404 4.32895 9.98795 -1.65029 -57.226 -17.8628 -509 2 50.0322 5.66893 9.41362 -36.2334 -9.83443 -38.9072 -510 3 49.3598 6.44562 10.1062 15.3309 6.40082 -5.38514 -511 4 50.9085 2.84633 8.5071 12.3092 -10.0263 -3.45928 -512 4 49.5835 4.28149 10.7848 -3.38143 -13.253 14.1405 -513 2 51.7461 4.22789 10.5468 25.7206 14.4209 20.1557 -514 2 51.9023 5.17188 11.7283 -67.9962 -1.36338 64.1829 -515 3 50.9364 5.19004 12.6002 28.9599 1.18541 -41.9912 -516 3 52.9319 5.83594 11.9785 18.8411 2.87417 -24.5577 -517 4 52.4276 4.5214 9.72474 12.6887 -3.13287 0.413374 -518 4 52.058 3.21563 10.9647 -9.24198 7.66389 -16.6414 -519 1 50.112 5.78532 8.03139 7.52033 29.602 25.459 -520 2 49.6799 7.08933 7.40639 14.3534 -30.8181 22.5674 -521 2 48.2409 7.17209 6.9711 -2.24553 44.7474 7.57528 -522 3 47.5844 8.22961 7.08968 18.1939 -9.81929 5.41459 -523 4 50.7064 5.09112 7.53173 -12.638 14.3936 -6.22521 -524 4 49.7159 7.84119 8.19837 -7.36252 7.51614 21.2329 -525 2 50.7023 7.64954 6.44039 -16.0213 -40.4967 -48.4302 -526 2 50.7257 6.82423 5.08423 -13.7427 47.9405 2.4816 -527 2 51.6418 7.28287 3.94021 29.8472 39.248 73.299 -528 2 53.127 6.98483 4.24688 1.29977 19.7271 -18.9866 -529 1 53.757 7.95176 5.17575 -11.1866 13.844 -62.5277 -530 4 51.636 7.68275 6.97838 28.3767 1.23741 1.58475 -531 4 50.4129 8.66535 6.18803 -0.179632 23.7408 -3.11047 -532 4 49.7187 7.01043 4.64523 -5.97611 -10.1095 1.48316 -533 4 50.8061 5.7562 5.2149 3.4405 -22.8364 10.0865 -534 4 51.5118 8.41472 3.72654 -1.36136 -26.6124 -3.74792 -535 4 51.4228 6.66542 3.12568 -20.7249 -22.8033 -58.4365 -536 4 53.6095 7.03345 3.2004 3.85152 5.93338 28.8514 -537 4 53.3314 5.96083 4.57939 -0.112253 -9.13532 8.29834 -538 4 53.309 8.86524 5.1699 0.162268 -2.42959 1.84412 -539 4 54.6672 8.17057 4.81193 19.2107 -0.812718 7.6593 -540 4 53.869 7.69009 6.11536 0.991087 -15.435 33.6166 -541 1 47.7293 6.1299 6.36528 -13.6545 -50.1986 -45.913 -542 2 46.4151 6.11998 5.73127 12.5517 -4.35851 26.1033 -543 2 45.4457 5.24236 6.50095 -54.5114 -4.35957 -22.3583 -544 3 44.2134 5.34166 6.22856 33.5613 3.36987 15.344 -545 4 48.2957 5.29705 6.08439 -4.65701 16.0313 11.2062 -546 4 46.0246 7.14829 5.83676 -12.413 4.85954 -1.2939 -547 2 46.3966 5.7006 4.23247 16.9743 -35.0719 19.3242 -548 2 46.8471 6.79722 3.31369 7.95245 13.9142 -51.9109 -549 2 46.0679 8.12855 3.29075 19.7668 12.2354 20.4517 -550 3 44.9703 8.28242 2.6836 -5.20426 -7.76074 -7.99938 -551 3 46.5716 9.08042 3.9624 -5.49585 -3.27174 -8.75295 -552 4 45.3525 5.37075 3.98324 7.30106 1.55378 -6.68576 -553 4 47.1483 4.79199 4.10624 -28.8106 21.423 0.303262 -554 4 47.0017 6.41037 2.24023 -12.0684 6.13088 18.9752 -555 4 47.8815 7.05675 3.60692 6.175 4.12296 2.89493 -556 1 45.8802 4.28795 7.34048 -32.7588 9.8199 -6.22093 -557 2 44.9801 3.41661 8.05582 7.11941 -0.762777 6.83491 -558 2 44.2841 2.32798 7.24802 57.2007 25.2815 -35.4523 -559 3 43.4338 1.62321 7.71908 -38.784 -24.7635 26.1598 -560 4 46.8556 4.13399 7.46211 34.7056 -9.13536 7.69054 -561 4 45.5867 2.90913 8.82837 -2.10841 -5.06197 5.41207 -562 4 44.2233 4.00883 8.63057 1.71074 -0.990438 -6.10924 -563 1 44.7516 2.08483 5.98824 -37.8462 -38.4135 -8.16449 -564 2 44.1597 1.01431 5.13579 -9.65639 -34.378 14.28 -565 2 44.8664 41.5016 5.49089 -11.1964 37.9598 3.64882 -566 3 46.103 41.4369 5.57345 -11.1149 2.47206 2.88353 -567 4 45.5262 2.474 5.47152 21.0389 22.2918 12.8005 -568 4 43.0172 0.862184 5.40503 31.5022 14.6416 -15.142 -569 2 44.4162 1.4085 3.60515 5.8653 -21.2021 14.2009 -570 2 43.5161 2.65984 3.27425 41.0117 -18.0627 24.5931 -571 2 44.2213 0.116838 2.67583 -30.001 3.65408 12.6342 -572 2 43.604 3.10049 1.82796 -41.0466 14.5447 22.3036 -573 4 45.4923 1.71966 3.57573 -0.138156 -3.02814 -11.6903 -574 4 43.8008 3.50537 3.97163 -2.46499 -4.10631 -11.566 -575 4 42.524 2.38704 3.60859 -29.3388 -0.685173 -5.23931 -576 4 44.5714 0.285197 1.65031 -2.2735 9.46305 -11.1841 -577 4 43.1006 41.7553 2.65834 21.2852 6.7215 -5.00379 -578 4 44.7366 41.0658 2.93547 0.768749 11.7185 9.28335 -579 4 44.5004 3.68719 1.60884 14.6444 -0.878149 -7.94907 -580 4 42.7371 3.8089 1.73084 7.8177 -0.664582 -10.9353 -581 4 43.3892 2.25631 1.16493 5.07933 -5.28874 -15.8541 -582 1 44.0858 40.4147 5.76991 -7.82686 10.7063 0.0613705 -583 2 44.6952 39.2248 6.26612 46.8291 -49.1328 2.55503 -584 2 45.6273 38.4983 5.15014 -10.8203 -24.5871 -10.3389 -585 3 45.1671 38.1033 4.04814 1.93862 22.6196 32.2907 -586 4 45.3114 39.4262 7.20071 -5.62912 7.00222 -16.0196 -587 2 43.5561 38.2867 6.74046 -22.632 -0.869913 -14.9675 -588 2 42.367 38.8131 5.80069 8.99216 14.1028 58.1483 -589 2 42.6345 40.3137 5.92605 0.476166 33.3948 28.8915 -590 4 43.357 38.4284 7.8368 -6.62566 13.9326 -12.0425 -591 4 43.8048 37.1922 6.7609 -3.60965 9.48681 -21.6917 -592 4 41.3136 38.6254 6.13023 8.266 -9.51845 1.65532 -593 4 42.4187 38.6156 4.74928 6.70678 -23.3061 -29.6074 -594 4 42.2773 40.816 6.98347 15.1971 -23.3227 -46.4987 -595 4 42.1119 40.8277 5.08767 -3.55372 4.4917 2.49103 -596 1 46.8487 37.9967 5.55394 17.2019 12.2692 25.006 -597 2 47.7247 37.0178 4.87762 -6.21972 -16.2302 -28.9734 -598 2 47.0354 35.8358 4.10675 -5.54108 30.4574 49.2069 -599 3 47.4638 35.4602 3.01706 -3.2731 6.26074 0.626287 -600 4 48.411 37.4477 4.12082 -11.0175 18.1135 -5.68521 -601 2 48.6499 36.5231 5.98749 -16.6595 -15.0747 15.7963 -602 2 48.891 37.7945 6.79307 0.637735 -25.9659 35.4869 -603 2 47.512 38.4108 6.81936 -6.06228 0.364124 -35.7901 -604 4 49.55 36.0027 5.64818 14.2665 0.926908 -8.4052 -605 4 48.1323 35.7432 6.6035 -1.04051 5.39171 0.916503 -606 4 49.6303 38.4539 6.33816 11.9938 9.28906 -4.17289 -607 4 49.2156 37.5316 7.87598 -0.828426 8.45001 -24.626 -608 4 47.6223 39.5002 6.92189 -5.61966 10.135 -2.25063 -609 4 46.9349 38.0418 7.65693 -11.0214 -6.34351 22.8142 -610 1 45.9811 35.3016 4.79343 19.1712 31.3513 11.165 -611 2 45.3118 34.1769 4.28537 -21.2148 -46.3229 -17.5718 -612 2 44.4751 34.4561 3.06273 -18.3812 8.00009 -33.6438 -613 3 44.391 33.6426 2.09905 3.94034 16.0457 30.0851 -614 4 45.6176 35.6832 5.71813 13.2063 -8.66839 -22.6288 -615 4 46.0373 33.4799 3.80083 11.0255 -0.404913 12.3267 -616 2 44.604 33.4055 5.40679 37.9095 -5.49339 -20.8443 -617 2 43.894 32.1911 4.95963 4.52806 -52.0805 -10.2655 -618 3 42.6666 32.0496 5.30411 26.1406 -7.63566 -17.5185 -619 3 44.6473 31.2926 4.419 -30.7677 19.4747 14.2469 -620 4 43.8381 33.9821 5.82617 -35.1808 40.951 30.2942 -621 4 45.3664 33.1691 6.19311 -10.275 -1.0365 4.4818 -622 1 43.9409 35.7078 2.94042 3.22733 -51.5357 -49.9186 -623 2 43.348 36.2006 1.70588 25.8776 -9.12573 -18.8138 -624 2 44.3757 36.8172 0.713167 -7.64912 -13.2689 38.6134 -625 3 44.0628 36.9589 41.4508 -2.41529 3.02373 -15.0868 -626 4 43.9087 36.323 3.69682 4.46748 41.5024 48.5675 -627 4 43.0059 35.3045 1.0879 -7.34341 13.0696 15.3539 -628 2 42.2218 37.2049 1.98307 -32.8685 -0.904888 11.5727 -629 2 41.1062 36.5938 2.90711 22.5622 20.6064 -2.77479 -630 2 39.8757 37.4913 2.92488 9.99264 -5.47282 62.3883 -631 3 39.5847 37.9927 4.02645 -6.88693 1.84466 -13.34 -632 1 39.0832 37.5519 1.86835 -2.09978 -20.426 -31.5908 -633 4 41.7044 37.4782 1.02484 10.2081 4.13789 1.30545 -634 4 42.5649 38.1527 2.49808 3.34998 -7.04672 -12.996 -635 4 41.496 36.4873 3.97615 -8.32458 2.86238 -16.0656 -636 4 40.817 35.592 2.59085 -6.50381 -15.3028 -7.15704 -637 4 39.3467 37.1489 0.943045 -1.18671 2.30285 11.2704 -638 4 38.1024 37.7997 2.00291 -4.61511 13.1634 -1.5169 -639 1 45.5865 37.1913 1.18701 0.34656 3.48246 -50.9957 -640 2 46.5715 37.7193 0.263736 40.0587 13.4866 27.3297 -641 2 47.1476 36.6709 41.2495 -9.99518 -39.8037 -22.9547 -642 3 47.6611 35.6473 41.7682 -3.12622 19.3551 -24.5438 -643 4 45.9505 37.0475 2.10099 0.0710674 -6.02767 36.3056 -644 4 46.0766 38.4733 41.5789 -9.05589 19.6465 -18.4972 -645 2 47.8462 38.4064 1.04164 -24.5048 14.2529 -26.5929 -646 2 47.4036 39.6651 1.82888 -3.7708 6.53308 31.1421 -647 2 48.5926 40.4064 2.51341 13.2626 3.99863 -2.76696 -648 3 49.7104 40.5691 1.98441 -24.6046 -10.5895 -1.86534 -649 1 48.3407 40.8898 3.74779 29.4138 -3.81739 16.8938 -650 4 48.597 38.7482 0.246377 -8.81496 -5.86425 14.2737 -651 4 48.3893 37.7509 1.72975 1.66752 -15.4435 3.74234 -652 4 46.6019 39.4971 2.66308 23.3117 -7.11271 -27.0857 -653 4 46.9261 40.3559 1.12913 -3.21242 13.4997 -7.95635 -654 4 47.3907 40.9351 4.12169 -5.60594 2.69026 7.41827 -655 4 49.1659 41.1473 4.37984 -25.8317 -2.18268 -20.985 -656 1 47.0143 36.8241 39.8589 2.94896 -6.17569 33.9376 -657 2 47.6738 36.0506 38.8108 16.6825 -23.5637 34.6067 -658 2 48.454 37.0258 37.9695 9.24498 -19.2444 17.2828 -659 3 47.9734 37.5867 37.0249 -16.9661 22.5794 -32.933 -660 4 46.3407 37.4883 39.4677 -2.13376 9.43233 0.449621 -661 4 48.4374 35.3321 39.3605 -24.6855 17.1776 -23.0678 -662 2 46.6968 35.2528 37.909 -27.9143 -33.2437 25.7199 -663 2 46.039 33.9895 38.7043 9.93401 10.5983 7.56799 -664 2 46.87 32.6784 38.9289 23.0786 -0.450758 -24.5995 -665 1 47.7656 32.5928 40.0651 -0.0346617 67.7235 50.2506 -666 2 48.5337 31.5574 40.3699 -14.5633 -26.8579 -35.9878 -667 1 48.7282 30.552 39.4879 -2.05986 8.25564 18.106 -668 1 48.8872 31.3858 41.6213 -4.84512 27.348 -3.11289 -669 4 47.2327 34.8627 37.0058 -5.81127 5.13112 -1.60937 -670 4 45.8267 35.9464 37.6192 18.3744 -10.9215 -5.83414 -671 4 45.065 33.6697 38.178 15.3305 12.1509 10.6411 -672 4 45.8045 34.3704 39.7428 -14.1926 -3.74807 -10.9265 -673 4 47.5159 32.4832 38.0006 -21.4463 1.51143 8.96621 -674 4 46.1858 31.8178 39.0967 -9.12823 -0.449275 -15.1225 -675 4 47.7485 33.3794 40.8208 -8.02877 -26.8637 -33.9869 -676 4 48.3609 30.5297 38.5261 -2.43008 2.66571 1.08755 -677 4 49.1746 29.6933 39.8011 5.57148 -11.3344 1.43527 -678 4 48.5595 32.0107 0.447997 -4.49593 6.14729 8.57279 -679 4 49.3675 30.5632 41.8859 20.5825 -37.41 17.1512 -680 1 49.6971 37.2567 38.3612 38.8031 36.8466 -19.9315 -681 2 50.6251 38.1764 37.6375 5.59701 -6.58181 11.8605 -682 2 51.1059 37.476 36.33 -5.39593 -3.52342 3.95062 -683 3 51.4567 36.2851 36.3473 -6.1727 9.88097 2.62067 -684 4 50.1666 36.6257 38.9842 10.5469 -17.0261 18.2142 -685 4 50.0436 39.1015 37.4003 1.48542 -2.85918 -9.88003 -686 2 51.8783 38.6033 38.5414 -14.1699 17.2606 4.5582 -687 2 51.4771 39.4948 39.8067 23.634 -8.13025 9.13717 -688 2 52.8025 39.6936 40.6861 -45.72 0.0787629 30.9804 -689 2 51.0312 40.8873 39.3543 -1.21924 6.71403 17.5275 -690 4 52.6247 39.2003 37.9187 -12.0326 -10.2321 5.24388 -691 4 52.4336 37.7304 38.9418 -1.83231 -8.6555 -7.07863 -692 4 50.6844 38.9864 40.4458 6.67436 6.37453 -9.78056 -693 4 52.9275 38.7652 41.2899 1.57503 4.15297 5.5095 -694 4 52.875 40.6185 41.4124 -9.95772 -27.9304 -22.9777 -695 4 53.6477 39.6981 40.0479 39.2622 9.27083 -23.1198 -696 4 51.882 41.4315 38.8764 -8.78739 -1.58992 -12.4168 -697 4 50.8284 41.5065 40.2813 -10.0843 -5.65437 -12.2377 -698 4 50.1041 40.7893 38.7156 9.84678 12.7352 4.22225 -699 1 51.1335 38.2092 35.1872 23.4477 43.7196 -18.1994 -700 2 51.5372 37.7272 33.8205 5.66277 23.826 53.2621 -701 2 52.816 38.5373 33.39 -13.9696 27.2523 3.91394 -702 3 52.9014 39.7954 33.5824 -9.48934 -35.8428 -1.88315 -703 4 51.0917 39.2914 35.1751 -6.07189 -44.7564 8.7296 -704 4 51.807 36.6734 33.9114 3.67702 -17.8942 -3.77347 -705 2 50.2728 37.942 32.9627 24.5619 2.20768 -27.072 -706 2 49.0946 37.0552 33.3907 -40.4332 32.861 4.12747 -707 2 50.6582 37.6771 31.4819 -4.87136 -12.6088 -15.1928 -708 2 49.1924 35.592 33.2496 18.605 -47.1891 -10.6734 -709 4 50.0222 39.0181 33.0462 -10.0421 3.96713 0.824793 -710 4 48.1822 37.369 32.7965 11.3859 0.507389 5.43773 -711 4 48.766 37.227 34.4352 6.35082 10.8857 5.72377 -712 4 49.7261 37.457 30.8365 21.3715 9.42576 10.5226 -713 4 51.3528 36.7896 31.3856 -11.4398 6.26312 1.5823 -714 4 51.2274 38.5516 31.0485 -10.0605 -6.0953 1.35419 -715 4 50.1827 35.2313 33.6939 -19.2762 -1.86106 -7.31237 -716 4 49.1345 35.3223 32.1629 6.46074 -3.78635 4.92713 -717 4 48.3248 35.0641 33.7333 8.66481 1.90115 0.669024 -718 1 53.7674 37.8522 32.7049 -0.401058 29.0536 2.76503 -719 2 54.8534 38.494 31.9889 21.3589 25.2573 -50.7784 -720 2 0.070256 37.9331 30.5159 -12.6617 -10.513 26.1463 -721 3 0.610536 36.8336 30.3273 -13.153 9.14635 -3.0322 -722 4 53.7049 36.8532 32.6778 5.78014 -33.2974 -6.55066 -723 4 54.4976 39.583 31.7137 12.734 -24.0185 30.659 -724 2 1.32523 38.4582 32.6174 -11.2306 -14.0383 43.8112 -725 2 2.25298 39.4244 31.93 21.239 -3.52493 -6.53852 -726 2 1.82142 40.7594 31.946 9.01925 8.15494 1.3639 -727 2 3.55305 39.1373 31.3858 -52.1121 -37.4601 32.7366 -728 2 2.62719 41.7738 31.436 16.1375 42.966 -9.20235 -729 2 4.2717 40.1621 30.8907 55.019 31.5071 -38.7093 -730 2 3.8753 41.5182 30.8618 10.3374 -30.1635 6.5347 -731 4 1.72137 37.3957 32.6071 -2.968 13.2806 -7.3675 -732 4 1.36361 38.7573 33.7485 -10.0277 -6.08615 -32.1159 -733 4 0.900203 41.04 32.4671 -4.90014 4.47018 0.827909 -734 4 4.05865 38.1292 31.3848 -19.507 10.3261 2.47632 -735 4 2.40669 0.963664 31.507 -12.4107 -17.8541 2.52862 -736 4 5.22734 39.8163 30.4261 -2.17835 18.3508 4.41679 -737 4 4.61313 0.382875 30.4956 -18.9116 -9.53382 4.9162 -738 1 54.5208 38.7001 29.536 -17.794 9.59417 2.44526 -739 2 54.4433 38.3677 28.0932 0.413701 6.77287 11.8816 -740 2 53.8236 36.9714 27.8054 -10.5704 38.9519 24.3324 -741 3 54.2836 36.1684 27.0139 12.3723 -16.7122 -9.38408 -742 4 54.0063 39.582 29.8758 15.9225 -27.1932 -25.0825 -743 4 53.6617 39.0994 27.7122 21.1252 -9.31914 -10.5745 -744 2 0.84771 38.4562 27.3872 5.21129 26.4327 0.415045 -745 4 1.55752 39.2926 27.6564 -22.375 -0.429945 3.27523 -746 4 0.737328 38.5366 26.268 -0.662808 -7.52676 8.67249 -747 4 1.44048 37.5755 27.6711 3.3074 -14.1434 -6.0421 -748 1 52.6712 36.7812 28.4639 -34.4859 10.4254 42.9936 -749 2 51.8461 35.5981 28.5315 7.11639 -32.3641 19.2856 -750 2 52.1287 34.6607 29.761 72.1729 37.4894 -16.6197 -751 3 51.2969 33.8912 30.1393 -37.38 -39.1809 16.7772 -752 4 52.2301 37.5459 29.0797 18.7619 -22.9106 -24.882 -753 4 50.752 35.8045 28.6381 6.6344 10.4547 -3.03351 -754 4 51.9318 34.9661 27.6028 3.27123 7.03186 8.45077 -755 1 53.4041 34.6064 30.3039 -37.1524 -18.2668 23.7743 -756 2 53.8481 33.579 31.3343 19.9058 12.4048 -28.9308 -757 2 53.2753 33.7631 32.7245 -4.20442 17.2631 -10.7202 -758 3 53.3264 34.8931 33.2388 -7.00143 -11.8952 2.65621 -759 4 53.9984 35.4233 30.2821 14.046 11.4873 -9.55867 -760 4 53.5575 32.5679 30.9796 -2.97426 -3.20006 -4.3618 -761 2 0.441949 33.6673 31.397 15.483 24.485 -22.5221 -762 2 1.1159 33.1056 30.111 -2.52249 -22.0361 -11.2405 -763 2 2.65939 33.3504 30.0471 -29.7948 -11.8394 -36.8606 -764 2 3.5253 32.433 30.8659 3.71436 3.74322 35.9681 -765 1 4.92891 32.7835 30.8601 -3.73949 -14.6782 3.94495 -766 4 0.930008 33.1164 32.2052 -10.1795 -8.12889 21.2637 -767 4 0.820281 34.7554 31.5264 -17.1946 -20.5931 1.67355 -768 4 0.726808 33.5631 29.1693 -8.69229 5.5421 6.41341 -769 4 0.816642 32.0044 30.0112 14.0154 14.8269 0.94841 -770 4 2.76655 34.4177 30.2798 16.9839 11.3836 1.64388 -771 4 2.99027 33.2006 28.9712 -4.31169 8.16855 10.4317 -772 4 3.48024 31.3628 30.6286 -9.21502 -9.13385 -9.88849 -773 4 3.14214 32.5157 31.9169 10.307 -3.37241 -3.01155 -774 4 5.38024 32.7641 29.968 4.13535 -6.65161 -12.8027 -775 4 5.44585 32.16 31.4735 7.57437 4.94374 1.68638 -776 4 5.11721 33.7072 31.1652 -0.520286 24.3887 13.7994 -777 1 52.7286 32.6609 33.3217 21.3895 7.82715 -40.48 -778 2 52.3746 32.6765 34.6845 -3.94215 -5.7204 42.1903 -779 2 53.6544 32.9612 35.4718 -32.0777 16.7216 -3.31611 -780 3 54.7101 32.4293 35.2196 26.5529 -12.799 -1.69002 -781 4 52.7346 31.7402 32.8358 -3.66087 10.5856 2.03104 -782 4 51.6553 33.4893 34.886 -4.93781 11.2662 -7.45083 -783 2 51.7389 31.3462 35.1425 36.1525 -8.24878 -2.45066 -784 2 50.4549 31.4357 35.902 -2.56298 9.46411 57.003 -785 2 50.5914 31.9702 37.3969 -4.77582 -10.2539 -35.2763 -786 3 49.9129 32.941 37.7385 4.53321 10.1718 7.36032 -787 1 51.4448 31.3274 38.2318 1.89331 10.2207 20.9211 -788 4 52.4532 30.7011 35.7138 0.934865 4.72627 -2.3237 -789 4 51.5619 30.7887 34.2312 -11.1921 -21.1455 -14.7508 -790 4 50.0197 30.4197 36.0127 -8.03636 -0.273264 -6.56567 -791 4 49.7685 32.1089 35.3545 -11.9583 -2.57651 0.31815 -792 4 51.7323 30.3416 38.1022 2.22495 5.18328 -8.30147 -793 4 51.645 31.7871 39.1631 -4.2657 -12.8631 -21.1898 -794 1 53.54 33.8952 36.4131 -39.2018 -0.531466 -0.79929 -795 2 54.5682 34.2648 37.3102 -29.3437 58.7358 21.9421 -796 2 54.3255 33.5954 38.6431 29.6978 -77.406 0.637438 -797 3 53.3742 33.7807 39.3881 -15.8118 22.9548 5.85491 -798 4 52.6165 34.3686 36.5483 14.9252 -1.63515 2.31459 -799 4 0.525104 33.9954 36.8979 32.3496 -27.0675 -4.05845 -800 2 54.6285 35.827 37.4074 -17.7645 -17.3983 39.0191 -801 2 0.013954 36.4546 36.058 15.6745 -1.04323 18.583 -802 2 0.049019 37.9526 36.293 -63.1087 6.90888 -39.4544 -803 2 1.42802 35.9308 35.6826 4.08802 -6.56861 34.108 -804 4 0.435555 35.9801 38.2063 -13.4425 16.5914 -13.2273 -805 4 53.6198 36.2963 37.798 28.292 -21.2068 -7.80607 -806 4 54.2061 36.2134 35.3084 7.36084 -1.04605 -3.46995 -807 4 54.0713 38.2397 36.8522 27.1057 4.55429 -9.55418 -808 4 54.939 38.4282 35.2643 6.0019 1.58695 18.2366 -809 4 0.927863 38.3313 36.762 28.685 14.2218 21.5028 -810 4 1.30489 34.8989 35.3991 1.43296 -22.664 -21.4406 -811 4 2.25694 35.8344 36.4845 -24.5016 17.8738 -12.6534 -812 4 1.83634 36.4362 34.8335 13.635 15.7788 -26.8996 -813 1 0.008587 32.3758 38.733 13.7846 27.3237 -75.0314 -814 2 54.826 31.3 39.6331 17.4428 -14.6066 45.4768 -815 2 0.455793 31.7866 40.9725 -5.37526 1.66294 14.9859 -816 3 1.60943 32.1773 41.0547 11.2247 3.92934 -7.13086 -817 4 0.661532 32.0877 37.9163 -19.8505 19.9989 33.4434 -818 4 53.7452 31.1425 39.875 0.374502 -5.35979 -15.722 -819 2 0.574437 30.0043 39.0439 11.2157 23.6116 11.9724 -820 2 0.334302 28.7136 39.8578 -22.6665 -11.1233 -21.4622 -821 2 0.695999 28.7 41.3625 12.0844 -36.9796 9.0265 -822 3 54.7253 28.727 0.298109 10.889 15.3071 -4.11946 -823 3 1.91063 28.4506 41.7261 -30.7481 15.8042 -10.4483 -824 4 1.71086 30.1341 39.082 -19.7243 9.32222 0.312381 -825 4 0.358791 29.9926 37.9166 -2.62684 -19.8589 21.79 -826 4 0.882365 27.912 39.2891 -0.232785 0.308618 14.1734 -827 4 54.2301 28.3798 39.7718 17.2545 10.1943 -0.206185 -828 1 54.6325 31.7916 0.156881 38.5875 2.07504 -29.8841 -829 2 54.8631 32.3302 1.45975 7.41407 33.4343 26.7616 -830 2 1.21087 32.0241 2.20189 -33.1211 2.89979 -4.9396 -831 3 1.57835 32.811 3.08735 12.0797 -3.2377 -11.0832 -832 4 53.6756 31.6317 41.8616 -38.5912 -7.03962 0.740029 -833 4 54.9627 33.4927 1.3754 -11.7864 -35.033 -4.32612 -834 2 53.6666 32.0355 2.42828 -17.6969 8.95863 -1.18459 -835 2 52.1933 32.3158 2.0402 15.1012 41.0915 -15.9482 -836 3 51.3911 33.0513 2.74715 36.5037 -34.5123 -13.5772 -837 3 51.9207 32.0348 0.835441 -22.1157 -3.97518 6.29873 -838 4 53.9089 32.5595 3.33158 -2.01457 20.6007 30.7692 -839 4 53.6609 31.0051 2.75768 6.68313 -26.6133 3.27231 -840 1 1.77413 30.8239 1.99288 23.346 -11.0551 12.4557 -841 2 2.99412 30.3649 2.70859 20.7873 20.7026 2.58588 -842 2 4.37767 30.5585 1.9432 -4.58172 12.4342 76.2013 -843 3 5.43315 30.6356 2.6242 -17.4542 -1.84538 -14.1099 -844 4 1.23141 30.1158 1.49013 8.16278 -4.42375 -5.05013 -845 4 3.08709 30.9756 3.71749 -2.54673 -19.312 -31.0286 -846 4 2.99418 29.2776 2.99437 -11.6108 14.2547 -3.21828 -847 1 4.33484 30.73 0.643592 -44.4777 10.1896 -41.2897 -848 2 5.29878 31.2923 41.6537 25.3276 0.744315 3.96016 -849 2 5.54544 32.7486 0.121481 37.2819 -30.872 -27.7426 -850 3 4.68176 33.387 0.67546 -18.5336 28.2868 17.8008 -851 4 3.3891 30.7154 0.224796 5.58966 -1.49205 -0.51948 -852 4 6.30256 30.8588 41.8823 -3.47112 -15.4387 -8.82901 -853 2 4.8423 31.1802 40.1578 47.5835 -21.6785 -9.15502 -854 2 4.71332 29.7742 39.4637 -7.18766 34.2596 -8.85866 -855 2 5.63064 28.6968 40.0034 1.34917 -52.5839 -25.1875 -856 1 5.28494 28.1736 41.3081 -3.70672 3.58414 23.7744 -857 2 6.07557 28.0057 0.492928 -10.4577 4.69864 -29.3733 -858 1 7.37832 28.2278 0.392183 22.9004 -4.79637 26.256 -859 1 5.53705 27.6868 1.66636 -6.4094 -24.443 39.9026 -860 4 5.53303 31.787 39.5095 -0.196101 -2.7377 7.98036 -861 4 3.92152 31.7024 40.0755 -40.4143 20.5365 -6.7059 -862 4 4.89215 29.8961 38.3273 -2.53464 -0.592337 23.8175 -863 4 3.64677 29.4833 39.5295 -2.27017 -8.63927 2.61329 -864 4 6.69627 28.939 39.9328 9.42975 10.3347 -2.35439 -865 4 5.48992 27.7969 39.2806 7.04825 21.6687 20.0754 -866 4 4.27254 28.0467 41.4152 -4.83075 -3.28587 3.65899 -867 4 7.98538 28.2099 41.4852 -8.02405 3.18538 -21.0185 -868 4 7.94047 28.2423 1.24565 0.364194 -0.98827 11.7246 -869 4 4.53186 27.4078 1.78766 14.7644 10.3007 -8.4097 -870 4 6.1013 27.52 2.55737 -8.44391 7.70178 -27.0297 -871 1 6.79596 33.2006 41.6804 -27.9344 8.59735 4.57792 -872 2 7.15148 34.5952 41.8655 -38.9276 -12.1291 -1.68573 -873 2 6.77215 35.2911 40.5652 14.0197 56.9428 51.8707 -874 3 6.49158 34.715 39.5569 -13.5951 -21.5425 -43.0675 -875 4 7.31858 32.7386 40.9072 -2.655 4.76346 14.1821 -876 4 6.52583 35.0505 0.829338 19.3934 -10.3795 -24.0216 -877 2 8.63545 34.7883 0.159249 -4.7809 22.3707 74.7553 -878 3 9.31911 34.1951 41.0459 32.4158 -10.9375 -20.7672 -879 2 9.12239 34.1481 1.54228 -45.3508 12.3646 -39.5443 -880 4 8.86138 35.9031 0.177513 1.59938 -13.4643 1.18346 -881 4 10.1943 34.4871 41.2598 15.0836 -7.29109 -20.5697 -882 4 10.1218 34.4779 1.7295 32.9793 8.82002 13.7556 -883 4 9.1354 33.0404 1.45915 -3.89828 -1.77159 7.54964 -884 4 8.44695 34.5279 2.36236 9.39315 -9.78399 0.0431608 -885 1 6.96309 36.6454 40.6555 -22.2962 -38.3404 -33.8498 -886 2 6.94214 37.5275 39.5132 -15.3576 22.9899 27.1878 -887 2 8.03225 37.1821 38.5547 25.8315 2.87875 -39.3086 -888 3 7.87409 37.2091 37.3037 -11.7489 -2.94068 30.2829 -889 4 7.09017 37.0079 41.5812 4.58243 22.402 24.7274 -890 4 6.01646 37.4072 38.9238 -6.0018 -8.28766 -1.15408 -891 2 7.01182 39.0163 40.0252 -15.3603 -23.3284 55.3652 -892 2 5.61926 39.5384 40.7634 13.0639 11.727 -14.3013 -893 2 5.74741 41.0778 41.0735 34.612 -8.65688 -61.1535 -894 2 4.30485 39.278 39.9775 33.2171 6.29002 -24.4772 -895 4 7.23253 39.6079 39.1676 9.01238 29.648 -28.6912 -896 4 7.91826 39.1206 40.7867 -28.368 0.120823 -25.2036 -897 4 5.4532 38.9933 41.7239 13.5286 -1.18368 4.70417 -898 4 4.88701 41.4539 41.5866 -22.2749 9.39049 21.0562 -899 4 5.89633 41.7578 40.1185 -8.19165 -26.548 25.276 -900 4 6.67066 41.2365 41.6556 -0.494064 4.57358 11.7906 -901 4 4.18164 39.8273 38.9933 8.48456 -7.17755 11.4037 -902 4 3.44244 39.5261 40.5797 -17.807 1.17877 7.97341 -903 4 4.2824 38.1939 39.7929 -10.4691 -3.8299 -8.01616 -904 1 9.23783 36.8543 39.0653 -4.40645 21.0053 19.4908 -905 2 10.3275 36.5838 38.1582 31.0816 -25.3995 62.8998 -906 2 10.2997 35.2224 37.4613 6.04581 38.1949 -0.210763 -907 3 11.0208 35.1071 36.4655 -6.3656 -14.3958 -11.0193 -908 4 9.51333 37.1441 40.0706 -14.9717 -14.5173 -38.8343 -909 4 10.386 37.3498 37.3821 -1.67567 12.3369 -13.0834 -910 2 11.6168 36.6846 39.0604 -5.3878 -32.5356 -23.0633 -911 3 11.6818 35.7254 40.0985 -18.2206 13.507 16.8431 -912 4 11.7318 37.6647 39.5052 6.99822 20.9023 2.76215 -913 4 12.4798 36.426 38.4299 12.1644 16.7594 -11.1747 -914 4 12.2479 35.0511 39.7675 10.0745 -20.8981 -3.76732 -915 1 9.3909 34.3264 37.8733 -42.427 -15.3638 26.6935 -916 2 8.99216 33.1557 37.0842 54.1918 17.4661 1.85655 -917 2 8.44195 33.5842 35.7305 -20.833 60.571 55.2199 -918 3 8.45395 32.8337 34.8033 7.91235 -41.3122 -40.5547 -919 4 8.901 34.4208 38.8182 18.72 -3.57692 -25.7233 -920 4 10.0039 32.69 36.8915 -15.1884 -12.4868 -9.34361 -921 2 8.05349 32.1507 37.7268 -1.844 -26.1592 7.76215 -922 2 8.63612 31.2276 38.7905 8.98886 15.2457 3.52798 -923 3 8.28567 31.4376 39.9878 9.18033 -14.5703 -9.08999 -924 3 9.46172 30.3301 38.4185 -14.4281 10.7169 -2.66077 -925 4 7.57008 31.4717 36.9797 -4.32683 11.3708 2.99534 -926 4 7.24557 32.7088 38.1955 -18.7592 7.98312 4.87833 -927 1 7.76821 34.7903 35.7104 -0.921577 -49.5867 -7.77983 -928 2 7.00589 35.2713 34.5947 28.4194 33.7396 -49.4054 -929 2 7.85162 36.3274 33.7967 14.0615 10.3677 50.876 -930 3 7.59561 36.677 32.642 -11.5138 -12.0529 -0.0837023 -931 4 7.64044 35.3156 36.5601 -2.79577 12.0246 16.4277 -932 4 6.95142 34.464 33.8059 -8.74679 1.13416 10.6726 -933 2 5.60472 35.8897 34.9384 -10.82 -34.5279 -29.2679 -934 2 4.80808 34.6511 35.4252 21.4048 19.1212 -24.4535 -935 2 4.58939 34.449 36.7896 -8.79739 7.49237 6.99756 -936 2 4.44707 33.6361 34.4808 -22.1156 13.6667 13.0483 -937 2 3.78406 33.375 37.155 10.056 16.8174 60.0349 -938 2 3.57928 32.5992 34.8543 35.6828 20.067 14.4288 -939 2 3.32606 32.5122 36.2195 -36.4887 -32.5961 -12.2866 -940 3 2.43989 31.6229 36.7148 -5.7594 -17.052 -20.0699 -941 4 5.14192 36.3424 33.9886 5.39246 -18.3577 14.2305 -942 4 5.60606 36.7583 35.5989 7.01287 1.52307 19.367 -943 4 4.94491 35.1783 37.5598 -4.47364 -7.92921 -7.91861 -944 4 4.66046 33.7427 33.4202 4.87397 4.4658 -8.40916 -945 4 3.45738 33.1597 38.2449 15.2806 17.1295 -26.8514 -946 4 3.26795 31.828 34.148 -6.61111 -3.61155 -4.72788 -947 4 2.1868 31.1622 35.9134 -6.91994 -9.03483 11.406 -948 1 8.90205 36.8981 34.5027 -17.2687 17.5401 -60.9896 -949 2 9.70361 38.0134 33.9387 24.2231 -52.0812 37.3823 -950 2 8.8546 39.1711 33.5701 14.7092 18.0593 -4.53516 -951 3 9.06515 39.7643 32.526 6.45085 3.58457 -7.26619 -952 4 9.11675 36.6435 35.4518 3.62665 -3.0608 21.1339 -953 4 10.3861 38.3235 34.818 -10.2978 3.44266 -21.7419 -954 2 10.5787 37.5562 32.7307 -21.6135 -30.8037 4.74181 -955 2 11.6892 38.5091 32.4223 15.379 -13.1594 38.9153 -956 3 11.683 39.1804 31.4042 4.19267 20.0472 -18.4805 -957 1 12.6852 38.53 33.3751 41.3863 26.0224 -13.8263 -958 4 9.85905 37.4261 31.8504 20.0453 2.40541 7.8736 -959 4 11.053 36.5467 32.9319 -7.17885 8.97611 -4.2567 -960 4 12.817 37.8369 34.166 -15.4043 12.1891 -16.4176 -961 4 13.5001 39.2408 33.2564 -39.0039 -25.8302 4.81098 -962 1 7.96197 39.5631 34.4599 -33.9246 23.5433 37.1278 -963 2 7.21007 40.8276 34.5568 -18.3646 -15.2096 -14.7898 -964 2 8.22007 41.896 34.9201 0.758716 14.3361 -6.26955 -965 3 8.97663 41.7874 35.871 13.0919 -8.40756 13.8683 -966 4 7.83943 39.0508 35.3409 8.95409 -9.59767 0.690263 -967 4 6.70734 41.0591 33.5261 17.9743 -2.28149 22.8597 -968 2 6.0301 40.6247 35.6674 21.3841 11.5647 -11.8815 -969 2 4.89974 39.9794 34.8247 17.8968 2.41192 -27.2216 -970 2 5.64567 41.9074 36.4174 -5.31946 16.9228 -22.0167 -971 2 3.85064 39.271 35.6143 -7.9417 -14.8054 48.1955 -972 4 6.41951 40.0018 36.4929 2.02391 -20.04 -2.41117 -973 4 5.36435 39.2019 34.126 -8.73918 7.93575 11.5905 -974 4 4.48342 40.7424 34.1094 -6.00744 -5.42447 8.5897 -975 4 5.00487 41.8434 37.3074 -11.5574 -14.3762 1.01334 -976 4 5.12929 0.689353 35.6946 7.17582 1.37977 8.89479 -977 4 6.56067 0.460605 36.8355 2.18467 8.54142 -3.2903 -978 4 3.23423 39.9796 36.2601 8.91814 -10.815 -11.4927 -979 4 4.38489 38.5352 36.333 -17.3309 14.265 -14.1697 -980 4 3.16246 38.6765 34.9814 -1.3822 0.0882741 -1.23744 -981 1 8.27901 1.09677 34.1745 -17.8694 -35.8502 15.8719 -982 2 9.1495 2.17731 34.4611 25.5007 24.1899 -15.5427 -983 2 8.44305 3.45517 34.8181 7.33507 13.3767 -14.0082 -984 3 7.22584 3.58853 34.5952 14.73 6.44535 13.4701 -985 4 7.64387 1.07834 33.3925 -5.10967 17.8437 -25.4682 -986 4 9.72616 1.98981 35.3795 6.67437 -11.367 8.50474 -987 2 10.1416 2.3939 33.2727 7.80857 1.28792 -5.65283 -988 2 11.1754 1.27875 33.0535 -29.5709 -1.62172 8.74553 -989 2 12.298 1.25902 34.0434 45.8123 -20.4226 -15.8942 -990 3 13.4264 1.60062 33.6211 -9.09849 2.20405 14.6225 -991 1 12.1286 0.499484 35.1615 13.5856 38.0862 1.93866 -992 4 10.7117 3.33658 33.4062 0.0269402 1.80508 0.780117 -993 4 9.62868 2.54332 32.3022 -11.3844 1.67988 3.84081 -994 4 11.6026 1.39089 32.0291 1.1132 -6.32648 1.88738 -995 4 10.6463 0.304077 33.1517 4.80745 -4.48978 -13.057 -996 4 11.1623 0.324257 35.4356 -7.1112 -9.24345 12.7946 -997 4 12.86 0.645961 35.8984 -11.3978 -13.87 -11.7385 -998 1 9.29061 4.442 35.2624 -22.3208 40.9019 24.8252 -999 2 8.81116 5.82611 35.6978 -18.3987 -9.60009 -41.1421 -1000 2 7.90959 6.36535 34.5148 35.1086 -14.4229 -13.6713 -1001 3 8.27789 6.14754 33.3333 -13.6173 9.04219 21.6414 -1002 4 10.326 4.35425 35.3433 -15.5473 -10.8229 -5.10085 -1003 4 8.07437 5.70026 36.5174 9.02025 -1.47766 10.124 -1004 2 9.99583 6.76313 36.1565 -25.1565 20.6308 -28.9867 -1005 2 11.135 6.93617 35.1361 2.62363 -10.5046 6.46017 -1006 2 12.4502 7.42969 35.8581 -25.4448 -27.2564 -27.4451 -1007 2 12.3858 8.85842 36.3442 -55.084 26.5775 24.6628 -1008 1 13.634 9.41318 36.7712 33.8844 -44.8334 11.878 -1009 4 10.2929 6.30703 37.0832 24.0012 -1.96783 25.2264 -1010 4 9.73373 7.84957 36.4159 -14.1304 -26.7275 0.147522 -1011 4 10.8081 7.68154 34.3572 5.16283 -4.02502 4.78839 -1012 4 11.298 5.9636 34.5725 5.23915 16.0099 8.41141 -1013 4 13.159 7.4137 35.035 25.5516 -2.14082 -10.0364 -1014 4 12.8083 6.68649 36.6117 -1.06896 6.08822 -0.205097 -1015 4 11.642 8.94716 37.2538 22.1051 -1.45756 -27.4817 -1016 4 11.9592 9.50431 35.5025 9.97141 -3.64215 15.7788 -1017 4 13.6538 10.3723 37.0555 -8.09423 13.3796 3.79584 -1018 4 14.2885 9.3339 36.0056 2.60625 13.8446 -5.44478 -1019 4 14.0928 8.83644 37.5176 -15.06 24.3666 -13.6607 -1020 1 6.73429 6.959 34.8261 9.36917 -0.537504 -3.37326 -1021 2 5.68914 7.48312 33.9811 -11.6093 0.198368 -29.7566 -1022 2 4.72257 6.43001 33.3633 23.9678 57.8121 29.6097 -1023 3 3.69345 6.80336 32.8731 -41.5354 18.269 -25.9458 -1024 4 6.5403 7.08067 35.8075 -8.4584 6.57489 23.7637 -1025 4 4.95828 8.08289 34.6274 18.5559 -1.63885 -10.0577 -1026 2 6.30301 8.33887 32.7628 1.61604 -0.894199 46.3222 -1027 2 6.96232 9.68302 33.2113 17.5203 -12.0258 -13.4607 -1028 2 6.11334 10.8061 33.8152 -7.60378 12.6352 19.0416 -1029 3 5.31496 11.4419 33.0422 10.0378 -5.26853 5.86857 -1030 3 6.28181 11.1536 35.05 3.36103 -18.7342 -31.8229 -1031 4 5.5011 8.60814 32.0808 -13.4162 -1.3456 -15.0867 -1032 4 7.01778 7.64283 32.2215 -8.51236 18.4517 -1.11608 -1033 4 7.483 10.1113 32.3225 -5.01151 2.49106 -4.14977 -1034 4 7.84021 9.44334 33.8428 -3.17944 -2.15711 8.7111 -1035 1 4.98957 5.17145 33.408 31.7294 -73.5208 5.3031 -1036 2 4.03057 4.12888 32.9492 20.6717 -14.7005 -20.2168 -1037 2 2.6598 4.36206 33.592 -3.0444 -3.65398 -36.823 -1038 3 2.63368 4.6245 34.7729 -17.9957 9.5377 28.5993 -1039 4 5.93287 4.88555 33.7778 -25.4301 -4.21673 -10.3446 -1040 4 3.97065 4.08898 31.7849 -0.621936 10.7688 28.6704 -1041 2 4.54797 2.73693 33.4323 -9.78314 13.2989 35.3654 -1042 3 5.7396 2.38581 32.8061 3.87836 -1.00687 -28.9834 -1043 4 3.83029 1.94659 33.1597 -9.96533 -6.0451 7.8725 -1044 4 4.7579 2.77573 34.5879 -14.8326 -6.64015 -28.538 -1045 4 6.39905 2.57303 33.4496 16.1931 5.10903 8.49462 -1046 1 1.55493 4.20465 32.7937 9.73391 7.12296 -2.26043 -1047 2 0.143907 4.28394 33.2313 13.768 -18.1657 13.0528 -1048 2 54.6863 2.83094 33.3214 -0.0746788 -18.1404 42.9803 -1049 3 54.7972 2.04898 32.3833 -5.36381 -6.57018 -20.4337 -1050 4 1.75536 3.84626 31.8337 -17.5999 5.97734 12.9737 -1051 4 0.145346 4.72929 34.2869 -5.52407 -1.41906 -16.7638 -1052 2 54.0936 4.99047 32.3072 48.5491 53.4262 27.9832 -1053 3 54.4431 6.39026 32.3568 26.5828 -36.1107 8.98461 -1054 2 52.7233 5.01429 32.8691 -55.1486 3.23885 2.70228 -1055 4 54.1505 4.66496 31.2868 0.0550865 -16.0071 -29.7017 -1056 4 53.7986 6.85268 31.88 -20.6445 25.8891 -20.893 -1057 4 52.6197 5.54793 33.8322 5.93951 -5.3567 9.34144 -1058 4 52.3467 3.98503 32.9647 -9.06602 -5.34833 4.63236 -1059 4 51.9747 5.55452 32.2255 9.49609 -7.51028 -3.22615 -1060 1 54.1802 2.39741 34.5222 -14.8232 32.9081 27.5353 -1061 2 53.4465 1.14651 34.785 33.9277 15.1 -62.0226 -1062 2 52 1.44639 34.4384 -40.9452 -8.29472 -14.3346 -1063 3 51.516 2.52365 34.8247 -1.26544 -9.47139 -8.9244 -1064 4 54.0715 3.07846 35.3501 9.6448 -17.4772 -31.2652 -1065 4 53.9076 0.391021 34.1043 -10.2836 -7.20705 -0.475865 -1066 2 53.6069 0.737389 36.2058 40.6624 3.41232 47.0409 -1067 2 0.15698 0.778637 36.8849 -22.9225 14.5477 7.59965 -1068 2 0.184063 0.045177 38.2545 -1.48959 -18.0819 6.68284 -1069 2 1.19764 0.213126 35.924 -17.0247 17.4527 -16.4279 -1070 4 53.1759 41.6554 36.3315 -4.28574 -19.6707 2.88188 -1071 4 52.9166 1.40322 36.7387 0.80484 4.57892 22.2756 -1072 4 0.570353 1.84035 37.1024 -27.1105 -11.6335 -5.02718 -1073 4 54.3756 0.329349 38.9832 1.77724 8.98271 -8.45905 -1074 4 1.16626 0.241414 38.7954 -11.8595 -7.79047 -8.4361 -1075 4 0.0237 40.841 38.1265 8.8292 11.305 -0.869273 -1076 4 2.1582 0.044818 36.439 11.171 3.86438 -4.7836 -1077 4 1.22244 1.0066 35.1406 25.1303 -1.4606 -0.0516333 -1078 4 0.965216 41.2564 35.3038 -8.75588 -20.9773 6.66787 -1079 1 51.2089 0.49816 33.7614 57.6433 8.13256 28.0245 -1080 2 49.794 0.627079 33.5149 3.58551 37.6409 23.5907 -1081 2 49.1504 41.7362 34.5845 -39.3958 -31.0429 53.6988 -1082 3 49.3072 40.5133 34.7023 12.9245 12.8492 -11.6005 -1083 4 51.5663 41.4343 33.8516 -6.054 3.49016 -14.1934 -1084 4 49.5236 1.72635 33.6347 -1.89472 -11.9516 -1.26615 -1085 2 49.2899 0.093076 32.2111 -20.0469 10.239 -57.1496 -1086 2 49.5504 1.0758 31.0546 44.1484 5.96661 -35.419 -1087 1 48.7105 2.02971 30.4517 -2.34523 -25.3315 39.2373 -1088 2 50.7977 1.22066 30.3277 -75.7848 7.88288 4.96893 -1089 2 49.299 2.59293 29.3763 -23.865 8.39496 11.0232 -1090 1 50.5677 2.14293 29.3127 -12.36 -15.4034 27.3398 -1091 4 48.1533 41.8436 32.187 18.4481 1.21563 9.00361 -1092 4 49.725 40.9798 32.0543 -2.35302 7.24771 -7.56512 -1093 4 47.7373 2.26457 30.8018 19.6426 -7.09987 -8.69392 -1094 4 51.6402 0.582035 30.3922 15.3203 -1.97636 0.19948 -1095 4 48.6832 3.25559 28.7541 24.649 -5.28154 -1.94766 -1096 4 51.2124 2.39582 28.5799 18.4236 6.97779 -14.3308 -1097 1 48.3633 0.438016 35.503 -1.69139 30.1001 11.6909 -1098 2 47.6687 41.7006 36.6492 0.613805 18.6924 -40.9612 -1099 2 46.264 41.3694 36.1307 -7.02361 -30.4834 5.87484 -1100 3 45.3463 0.246853 35.8895 18.8914 5.06283 8.3795 -1101 4 48.1281 1.45816 35.4039 5.5506 -16.4063 -0.101422 -1102 4 48.2062 40.7837 36.9784 6.36967 -2.21031 -8.42979 -1103 2 47.5958 0.687745 37.8565 -25.4558 59.2473 29.5222 -1104 2 46.6931 0.064749 39.0402 -2.78345 4.00632 18.8053 -1105 2 47.0383 40.4557 39.4221 -33.2538 18.6268 -20.4936 -1106 2 46.93 0.927044 40.3419 31.4794 -11.2994 1.29194 -1107 4 47.1354 1.76149 37.5629 9.48386 -42.5729 7.15928 -1108 4 48.6298 0.997945 38.2155 -14.6806 -19.3715 -2.98409 -1109 4 45.5391 0.148422 38.8474 30.3772 -4.98305 -7.99897 -1110 4 47.9695 40.2725 39.9165 32.6255 3.33763 11.188 -1111 4 46.9967 39.7545 38.5575 0.158611 5.44488 0.559019 -1112 4 46.2719 40.0836 40.1333 -2.82757 0.291607 -0.331179 -1113 4 48.0832 1.04093 40.5802 -35.3824 -1.71169 -8.39188 -1114 4 46.4823 0.388091 41.2333 0.118939 13.4124 -7.57083 -1115 4 46.4764 1.95182 40.2253 3.79994 -8.06745 5.67231 -1116 1 46.1155 40.0363 35.9994 32.2071 3.49142 -20.6914 -1117 2 44.9353 39.2817 35.7114 0.014229 -40.6503 61.2515 -1118 2 44.4179 38.8949 37.157 4.06758 -27.6469 18.473 -1119 3 45.1574 38.4668 38.0935 -15.0116 19.769 -34.2637 -1120 4 46.9934 39.487 36.0733 -14.8983 -9.5139 0.794979 -1121 4 44.1193 39.9156 35.4266 -15.9448 22.0113 -37.9939 -1122 2 45.2307 37.9502 34.8403 3.73878 29.7444 42.1248 -1123 2 44.043 37.0324 34.841 -52.9272 -13.7306 14.9234 -1124 2 45.6185 38.368 33.4399 7.42128 1.51593 -38.9882 -1125 4 46.0406 37.394 35.3664 8.69137 1.61483 -3.86581 -1126 4 43.4486 36.945 35.811 20.0159 3.18287 -12.2628 -1127 4 44.3645 35.9957 34.6605 0.118723 -8.68919 -11.9568 -1128 4 43.2413 37.3473 34.1301 7.80666 -3.9283 -7.25571 -1129 4 46.619 38.86 33.4411 -0.357581 -2.40345 0.816384 -1130 4 44.931 39.1517 33.0584 -3.3954 -0.0150932 -1.42103 -1131 4 45.65 37.5606 32.6192 -0.759822 9.78394 24.304 -1132 1 43.0637 38.9039 37.3301 16.2039 -1.11298 52.5829 -1133 2 42.3901 38.4825 38.6382 8.13363 32.9232 -36.228 -1134 2 41.8706 37.0909 38.467 10.8397 -12.8704 71.8875 -1135 3 41.4837 36.7016 37.4073 -23.2793 -18.8499 -56.9312 -1136 4 42.5052 38.9697 36.5072 -31.8536 4.61581 -21.2592 -1137 4 43.1805 38.4127 39.3754 18.2924 -0.774441 22.1039 -1138 2 41.3003 39.5089 39.1545 11.9555 -3.56475 0.849013 -1139 2 41.9844 40.8891 39.6202 11.8289 -38.672 35.4909 -1140 2 41.1032 0.170603 39.4187 0.299182 35.0028 -21.1028 -1141 2 42.4599 40.8175 41.1074 30.4283 -6.43954 -3.58257 -1142 4 40.7378 39.0113 40.0259 3.55617 13.764 -16.8053 -1143 4 40.5882 39.6834 38.2893 4.7664 -2.44084 15.6093 -1144 4 42.9174 41.0251 39.0897 16.4872 7.11459 -27.4623 -1145 4 41.5448 1.21778 39.6878 -5.64292 -30.3916 -9.38981 -1146 4 40.1969 0.063548 40.0003 -21.2204 -0.202137 11.1399 -1147 4 40.8028 0.152067 38.3319 -0.566182 12.1591 9.51378 -1148 4 41.6814 40.5448 41.8308 -8.42244 -8.91154 4.32363 -1149 4 42.887 41.7652 41.4977 -6.37808 7.37928 -6.87517 -1150 4 43.378 40.1338 41.1957 -24.337 0.845851 0.000130478 -1151 1 41.833 36.287 39.5864 -11.7269 -9.12911 -32.1296 -1152 2 41.2021 34.942 39.6247 -13.3362 -7.3841 -33.9439 -1153 2 39.8438 35.1095 40.3167 -2.23182 -18.8086 0.488263 -1154 3 39.8319 35.4679 41.5133 -14.6884 5.15074 -23.9167 -1155 4 42.1857 36.6275 40.4819 6.41783 1.01312 8.70708 -1156 4 41.0734 34.4248 38.4971 0.391294 34.8961 43.783 -1157 2 42.0436 33.9307 40.4129 10.4134 -33.9193 29.8386 -1158 2 41.3224 32.6645 41.0046 18.9395 -8.84266 -15.0635 -1159 2 42.1741 31.41 41.1086 26.4224 -37.0889 -5.20117 -1160 1 43.3231 31.527 0.12404 8.16009 54.2467 4.49909 -1161 2 44.392 30.7336 0.312631 -11.8213 -13.5239 -25.8004 -1162 1 44.683 29.6211 41.5456 -0.875823 -13.5136 -9.93246 -1163 1 45.3567 31.1357 1.10637 -40.5913 52.4111 16.4216 -1164 4 42.6035 34.3028 41.3288 -3.49471 12.9719 -23.3931 -1165 4 42.7742 33.539 39.6653 10.0701 4.50298 5.32726 -1166 4 40.5106 32.3417 40.3808 -25.7726 1.2565 -24.6898 -1167 4 40.8602 32.7415 0.05618 -15.4481 23.3498 31.3369 -1168 4 42.5775 31.2408 40.0556 -4.97325 -9.97334 14.9806 -1169 4 41.5239 30.4863 41.4302 18.1675 25.5375 -11.7586 -1170 4 43.4773 32.5278 0.495625 -12.2609 -36.3484 -6.98406 -1171 4 44.1847 29.2591 40.6938 -0.904676 10.2844 18.7349 -1172 4 45.5197 29.0942 41.8602 -5.70345 -5.08504 -8.10101 -1173 4 45.1981 31.9946 1.67722 9.89922 -9.52065 -4.53153 -1174 4 46.1063 30.5613 1.39407 36.7186 -26.409 10.0907 -1175 1 38.7328 34.6894 39.6013 4.46457 11.7984 -0.102478 -1176 2 37.3765 34.7683 40.1611 -21.3466 -3.56213 -4.53749 -1177 2 37.2086 33.6902 41.246 35.3807 -34.3386 -58.3615 -1178 3 37.7056 32.5617 40.9531 -12.3371 14.3328 36.9617 -1179 4 38.7903 34.2139 38.6548 1.70782 19.6852 25.699 -1180 4 37.2103 35.7436 40.6571 5.74575 10.1154 -0.0963519 -1181 2 36.2415 34.546 39.0669 -3.18027 -0.0437456 15.212 -1182 2 36.1408 35.6492 37.9204 39.4301 -27.8538 10.4422 -1183 2 35.3755 35.0392 36.7616 2.61616 7.91146 -44.6699 -1184 2 35.4893 36.9279 38.4153 -43.6456 26.6605 -35.0263 -1185 4 35.2587 34.5127 39.627 5.22859 0.340849 -7.95454 -1186 4 36.3572 33.4874 38.6664 0.260323 14.7009 0.217726 -1187 4 37.2087 35.8382 37.5664 -16.1128 3.65721 5.42823 -1188 4 35.4477 35.6456 35.7653 9.36321 -17.9472 26.5571 -1189 4 34.3056 35.0154 36.9225 -21.8403 -4.8414 12.2215 -1190 4 35.6878 33.9672 36.6241 -0.675121 9.51327 -11.2908 -1191 4 35.3533 37.7352 37.5449 14.646 -26.9923 30.0517 -1192 4 36.0883 37.365 39.2255 0.238586 8.99863 9.94523 -1193 4 34.398 36.7236 38.7331 27.4296 3.60145 2.66053 -1194 1 36.5178 33.9861 0.43319 -0.886806 18.5628 10.9627 -1195 2 36.4316 33.2481 1.68402 -23.714 -26.6299 -2.13495 -1196 2 35.1244 33.7124 2.42366 15.5385 -30.3313 2.36588 -1197 3 34.7644 34.9026 2.51705 2.20922 -14.5348 -10.7235 -1198 4 35.9714 34.8641 0.38304 3.21168 -9.87759 6.15105 -1199 4 36.3983 32.0948 1.44989 -1.82422 33.6343 5.26777 -1200 2 37.6595 33.5578 2.59019 11.8109 -15.526 -8.95992 -1201 2 37.7925 32.6548 3.8947 -1.46637 37.0951 -40.7395 -1202 2 39.0729 32.9162 4.76145 9.33062 17.9701 -6.69315 -1203 1 39.1272 34.3057 5.34055 -12.0513 -47.2871 -14.6565 -1204 2 40.0361 34.6964 6.22226 19.4309 2.99614 33.8109 -1205 1 41.0505 33.9844 6.76852 5.72064 -28.58 -41.8643 -1206 1 39.7581 35.8909 6.75898 -16.291 -41.0737 -43.8581 -1207 4 37.6558 34.6526 2.69615 5.74115 8.80853 20.4616 -1208 4 38.5677 33.342 1.97837 2.62182 1.38243 0.976295 -1209 4 37.7082 31.6119 3.52088 7.51898 -7.43262 10.1799 -1210 4 36.8684 32.8569 4.46033 -3.22235 -4.22142 15.6354 -1211 4 40.0987 32.7161 4.26669 -27.6432 -2.90908 0.926336 -1212 4 38.962 32.1623 5.56307 10.4764 0.325422 12.3641 -1213 4 38.2956 34.9173 5.26655 4.54825 -8.39051 -8.34855 -1214 4 41.5169 33.1039 6.38476 -28.6266 25.8655 1.14646 -1215 4 41.608 34.3491 7.51377 7.8916 19.9746 23.1278 -1216 4 38.9281 36.336 6.40181 -18.5651 19.0558 1.42199 -1217 4 40.2702 36.4189 7.40653 35.8571 19.9594 40.0309 -1218 1 34.4344 32.6714 2.9841 11.9274 27.4669 5.1488 -1219 2 33.2874 32.9292 3.81699 -8.08564 -7.68863 -5.88537 -1220 2 32.3224 31.7651 3.90854 -17.2979 -17.3182 38.1098 -1221 3 31.6331 31.611 4.98833 24.1293 6.49939 -41.9496 -1222 4 34.8176 31.7057 3.00707 -6.83555 3.8884 -0.368261 -1223 4 33.5991 33.291 4.83995 -4.39941 -8.915 -13.4113 -1224 4 32.6658 33.7351 3.38441 -0.220857 8.92322 -1.65762 -1225 1 32.2676 30.8833 2.86064 7.18924 -6.28537 -11.1453 -1226 2 31.5304 29.6622 2.84554 -44.3988 -8.55194 41.4736 -1227 2 32.0114 28.4719 1.98523 24.1065 42.5964 20.3644 -1228 3 31.2338 27.9142 1.1781 -2.45095 -15.5808 -11.9787 -1229 4 32.835 30.9065 1.99868 7.60542 11.1676 6.22148 -1230 4 31.4977 29.325 3.94534 -1.848 -5.68036 -21.1002 -1231 4 30.428 29.9278 2.63242 23.021 -11.1829 0.219584 -1232 3 33.2484 28.1785 2.03016 -12.1294 -5.65166 -6.61988 -1233 6 29.6841 33.0367 2.60309 -21.6771 -19.3453 -3.47113 -1234 4 28.7948 33.122 2.96731 -0.0142705 6.34055 1.55972 -1235 4 29.6278 32.12 2.27587 17.6678 13.2788 -5.74715 -1236 6 1.91248 24.7582 28.0699 4.20875 0.224039 17.8866 -1237 4 1.01839 24.445 28.2798 3.51323 0.855994 -2.65004 -1238 4 2.43926 24.5752 28.8738 -5.90795 -3.90565 -13.7536 -1239 6 8.97597 35.4266 7.06834 5.04 -9.06312 -1.25332 -1240 4 8.25108 36.0541 6.94232 -0.597114 -1.88223 0.564045 -1241 4 9.78632 35.9205 6.90416 2.6498 8.25727 -2.9232 -1242 6 37.9306 35.2271 23.5275 -29.4197 8.6633 8.88923 -1243 4 37.6331 35.3765 22.6307 -13.538 -1.59668 -6.74716 -1244 4 38.842 35.1051 23.4294 41.2281 -9.97035 -1.96517 -1245 6 11.37 34.6061 20.3231 29.8185 18.8627 -18.7977 -1246 4 10.4583 34.7066 20.5358 -23.2141 -5.0309 12.4901 -1247 4 11.7775 33.9686 20.9051 -0.738527 -14.291 8.66526 -1248 6 3.04799 13.1152 13.5136 35.0099 19.4917 13.0876 -1249 4 2.1896 12.8159 13.7818 -12.1985 -3.35561 6.33527 -1250 4 3.35102 13.7724 14.1976 -9.84998 -14.2313 -17.3692 -1251 6 9.17749 22.3786 24.885 -4.81993 3.49977 17.5169 -1252 4 8.99718 21.9861 24.0258 2.67933 0.293026 -6.97176 -1253 4 8.3097 22.5185 25.3032 2.93356 -2.2731 -6.67367 -1254 6 31.1417 36.1188 7.44168 3.96214 -4.62609 4.57576 -1255 4 30.9859 35.1633 7.26174 3.91063 19.8072 -8.10584 -1256 4 31.8759 36.4086 6.86762 -9.43736 -11.0335 0.220205 -1257 6 20.3122 0.171955 30.1364 24.228 8.43021 7.74329 -1258 4 20.1467 1.09565 29.8896 -9.06662 -5.17995 0.122132 -1259 4 21.2388 0.205679 30.4532 -11.6638 -2.99571 -4.85501 -1260 6 32.6752 3.01477 5.14905 7.73556 0.409651 25.0992 -1261 4 32.0607 2.27652 4.98052 6.16059 10.1356 9.58904 -1262 4 32.7887 3.0902 6.13894 -10.3787 -11.0045 -24.4474 -1263 6 26.2394 8.28697 11.5977 20.1187 4.68976 23.8355 -1264 4 26.2546 7.39802 11.997 -1.81228 7.23555 -2.12718 -1265 4 26.8422 8.82061 12.1901 -18.4274 -19.7459 -23.7973 -1266 6 1.08156 20.2558 0.892389 0.445896 -40.4816 -11.3523 -1267 4 0.921065 19.2784 0.845371 -9.22979 28.4068 22.5673 -1268 4 1.8129 20.2775 0.290341 19.5395 18.0975 -11.5753 -1269 6 29.152 22.9159 1.42964 -10.353 11.3862 1.77115 -1270 4 28.6638 23.7219 1.70393 12.045 -15.0113 -5.27942 -1271 4 29.6471 22.6066 2.20087 0.367353 7.17244 2.17898 -1272 6 34.1439 34.8173 6.47837 -14.6134 34.7664 -13.6599 -1273 4 34.8234 34.3556 6.01831 17.3611 -13.8412 -2.82442 -1274 4 33.8746 34.3136 7.2252 -0.385324 -14.0922 18.4225 -1275 6 25.1602 37.1811 26.5285 37.3138 -10.4299 -24.6025 -1276 4 24.6611 37.8475 26.9305 -29.1138 25.753 30.5337 -1277 4 25.9902 37.6718 26.3423 -2.02618 -10.7722 -5.27175 -1278 6 14.5359 22.233 15.6757 -38.1082 -52.4317 -17.2355 -1279 4 14.0373 21.3219 15.6008 31.4468 51.1923 15.0921 -1280 4 14.2115 22.7284 14.9124 6.42666 2.88962 4.6194 -1281 6 2.85765 5.85542 4.07926 -11.0889 31.9932 11.5474 -1282 4 3.43051 5.71014 4.8302 4.50985 -17.8875 11.7313 -1283 4 2.47546 6.74142 4.27679 -1.8522 -19.462 -7.62003 -1284 6 27.6173 26.7153 22.7048 3.02536 -24.7668 37.2 -1285 4 26.7794 26.2561 22.7471 -5.49099 -10.4557 3.23975 -1286 4 27.5338 27.2427 21.9498 -2.81898 29.5538 -40.3285 -1287 6 17.7815 0.60275 22.3967 -9.44347 22.192 16.8557 -1288 4 17.1106 0.664367 23.1174 8.05472 -4.70436 -13.4643 -1289 4 18.0991 1.53066 22.3547 -2.50437 -12.3009 -7.04453 -1290 6 8.08803 9.43976 10.5674 4.80966 -47.9744 28.0614 -1291 4 8.01535 10.2871 10.1695 -8.25869 32.7817 1.56345 -1292 4 8.12483 9.46261 11.5696 0.628604 12.1613 -30.4224 -1293 6 15.3459 8.71493 30.7579 -11.6347 7.91644 6.32427 -1294 4 15.6589 9.0755 29.9373 15.0271 -3.29406 -15.5675 -1295 4 14.5238 9.21191 30.8811 4.80809 -7.40019 11.405 -1296 6 11.0133 17.2839 37.5617 38.0352 -12.2544 -11.7999 -1297 4 10.7898 18.2056 37.405 -17.5453 -0.0751596 7.29682 -1298 4 10.2607 16.7791 37.8546 -17.0302 3.42722 4.74802 -1299 6 42.1004 25.1498 20.3879 -5.861 18.5914 -24.6259 -1300 4 41.6093 25.7579 19.7998 14.6917 -4.46771 2.10695 -1301 4 41.6207 25.2703 21.1911 -4.19275 -5.86855 25.2901 -1302 6 25.8665 4.70671 33.8486 1.7241 -2.25531 12.4518 -1303 4 25.7694 4.46132 32.9448 -0.891619 -14.6084 -22.569 -1304 4 25.7648 5.65611 33.7952 0.475958 14.7418 11.4125 -1305 6 28.7412 10.81 24.3536 52.8166 -39.1996 0.778281 -1306 4 29.1275 10.6396 25.241 -21.7381 14.0631 -10.6288 -1307 4 29.4032 10.2753 23.8346 -27.1554 16.6107 -4.2243 -1308 6 5.01189 41.8147 11.1021 -10.1881 -24.042 21.7575 -1309 4 5.95007 41.5814 10.9281 -9.39093 5.64723 11.7156 -1310 4 4.65803 41.218 11.8386 16.8172 15.7397 -32.6044 -1311 6 51.752 12.7769 30.1551 43.115 4.76279 10.9474 -1312 4 51.4305 13.1775 29.3474 0.253404 7.28674 -13.194 -1313 4 52.748 12.9494 30.1798 -32.3905 -5.4963 0.108494 -1314 6 7.60816 6.20909 6.53323 -10.2625 -22.9413 3.332 -1315 4 6.75131 6.36879 6.93991 1.04412 16.1391 1.16177 -1316 4 7.47061 5.28848 6.27373 8.51121 0.713964 -9.51027 -1317 6 14.6661 26.987 30.1548 0.873164 4.36141 0.355215 -1318 4 14.582 27.1099 31.1251 1.36022 -4.92112 -14.8153 -1319 4 15.2266 27.7026 29.8055 -8.21389 -0.931444 11.6021 -1320 6 15.3264 3.73283 21.1643 -10.33 -3.58504 -6.01241 -1321 4 14.8638 4.27764 21.8464 -0.83547 -19.2341 -16.6374 -1322 4 14.7237 3.15769 20.6119 12.9204 22.2517 21.9232 -1323 6 18.6273 30.44 6.46759 12.0392 -23.7352 17.6185 -1324 4 19.0475 29.6706 6.98693 -16.3462 35.3997 -15.3304 -1325 4 19.3457 31.0864 6.33287 -5.93154 -6.64461 4.30044 -1326 6 40.7697 1.30953 12.81 -7.42069 2.69181 -0.220133 -1327 4 39.8771 1.67487 12.9664 8.30469 -1.85755 -8.75546 -1328 4 41.0842 1.69163 11.9727 1.23155 -3.30642 0.910493 -1329 6 17.7383 20.7435 41.5913 -9.25323 7.68498 -13.188 -1330 4 16.7989 21.0745 41.5362 27.0903 -5.35562 -1.00027 -1331 4 18.2994 21.1605 40.9095 -9.45455 4.50919 10.4973 -1332 6 20.4558 2.13279 12.3403 -30.0447 18.1891 -47.0851 -1333 4 19.8108 1.39557 12.2573 15.3988 9.29294 19.6505 -1334 4 20.198 2.64755 11.5038 12.9177 -17.2886 33.121 -1335 6 9.85302 37.1833 18.074 6.71136 -14.9304 -23.7857 -1336 4 9.92221 37.5908 18.9423 10.0316 4.42551 4.50256 -1337 4 10.7455 37.1149 17.635 -18.8442 6.56171 18.5414 -1338 6 22.8282 7.40677 18.9114 -6.23678 0.804763 -35.7596 -1339 4 23.277 7.74075 18.0859 -11.7777 -2.90663 21.4919 -1340 4 21.8757 7.287 18.6972 16.9035 1.85128 0.334711 -1341 6 12.8573 6.85868 39.0594 6.78943 -21.4649 -19.4044 -1342 4 12.3495 7.63841 39.2092 -16.9303 20.8315 3.03628 -1343 4 13.4346 6.77393 39.8096 4.28484 1.06254 16.6435 -1344 6 10.1565 2.40612 23.2517 -6.6479 23.561 31.1588 -1345 4 10.4099 1.98923 22.4441 -4.01424 -6.38426 -29.0568 -1346 4 9.49005 3.10319 23.0571 9.63138 -11.2124 -3.87372 -1347 6 12.5542 20.2161 19.5705 -7.34833 3.07917 -34.9419 -1348 4 11.7057 19.8107 19.7825 -3.93433 -3.45282 3.31954 -1349 4 12.4683 20.3478 18.5882 13.2674 0.522362 30.6915 -1350 6 53.8557 6.35775 18.9347 50.5758 7.3162 -16.743 -1351 4 53.0168 6.07594 19.2456 -23.2698 -10.9568 16.0684 -1352 4 54.5479 6.04339 19.5529 -19.4302 5.44353 -5.27334 -1353 6 1.75058 4.00903 13.2441 23.5728 -28.6973 -20.2265 -1354 4 1.21884 4.54583 13.7916 -24.4496 15.7193 15.6535 -1355 4 1.39876 3.10072 13.3493 7.47096 11.1043 -1.96467 -1356 6 2.68902 16.4655 4.58797 17.5454 -16.7281 26.1549 -1357 4 3.46748 16.2798 5.17846 -23.6637 11.3752 -17.7986 -1358 4 3.0109 17.1109 3.97132 2.36318 9.59715 -15.9168 -1359 6 22.6274 7.40182 35.0529 -33.099 -8.93325 -69.8706 -1360 4 21.8922 7.07895 34.3703 46.348 20.1786 48.898 -1361 4 22.5995 6.76718 35.7474 -8.35572 -20.8537 22.0506 -1362 6 30.6396 27.885 19.9 19.0923 35.3411 -25.0547 -1363 4 31.1106 28.5954 19.3754 -18.5592 -24.8751 19.2783 -1364 4 29.9814 27.5098 19.295 5.17179 -8.35919 5.46264 -1365 6 18.3573 9.54392 6.2041 9.96047 7.12844 39.1223 -1366 4 18.327 9.09374 5.37857 3.10343 -12.6247 -24.8999 -1367 4 19.1177 9.18386 6.70986 -9.9052 0.872737 -11.1311 -1368 6 21.018 30.3894 30.8381 -12.2875 -2.46479 40.1773 -1369 4 21.7266 31.0151 30.932 9.98027 8.24448 -8.07198 -1370 4 20.7269 30.28 31.7939 -0.642204 -5.24287 -40.3987 -1371 6 28.323 4.36597 15.0837 1.12527 39.8195 10.6489 -1372 4 27.8986 3.55092 15.2676 -12.4099 -32.2848 2.02696 -1373 4 29.0009 4.19376 14.4446 14.1396 -7.65384 -8.86362 -1374 6 12.7814 0.64254 16.5262 -20.2521 41.8336 -1.49998 -1375 4 13.0387 1.47629 17.0069 -1.64601 -27.4009 -13.133 -1376 4 12.0897 0.933072 15.8712 20.715 -4.46996 16.4219 -1377 6 27.5603 35.1844 8.24072 -26.8161 -1.20469 12.7263 -1378 4 28.0791 35.3455 7.47089 6.94403 2.76433 -19.537 -1379 4 26.8275 34.582 7.96906 18.9853 12.4469 9.56437 -1380 6 24.0704 5.17451 40.9985 43.9791 -14.9803 45.716 -1381 4 24.6298 5.96615 41.2045 -19.6374 -8.83437 -20.0494 -1382 4 23.3625 5.28724 40.4007 -22.1054 20.8081 -27.5224 -1383 6 16.8467 24.9145 28.3061 -32.8066 71.0274 -23.4158 -1384 4 15.8676 25.1613 28.454 39.6061 -31.4713 1.92714 -1385 4 17.0718 25.6559 27.6632 3.37355 -28.1253 20.4487 -1386 6 20.8411 12.7971 17.0095 43.3655 -24.1139 -5.17775 -1387 4 20.9692 13.6698 17.4217 0.0861137 -1.96629 -7.53612 -1388 4 21.7712 12.4167 16.7645 -47.1299 18.5523 16.3808 -1389 6 35.7683 23.0344 30.9263 1.08866 -13.108 5.55839 -1390 4 34.803 23.1301 30.928 3.64223 -3.31893 2.04139 -1391 4 35.9803 22.5404 31.7512 0.26244 15.2618 -11.5602 -1392 6 36.3065 21.404 25.8788 21.1988 16.3215 -11.4752 -1393 4 35.3711 21.2912 25.8279 -29.04 -8.19979 -7.71966 -1394 4 36.6742 20.6179 26.2596 7.44281 -15.7003 9.85929 -1395 6 13.4865 6.74911 5.29345 -32.6693 78.3701 45.7352 -1396 4 13.9616 6.05619 4.98306 41.5093 -80.328 -47.9816 -1397 4 12.7805 7.00791 4.71674 -14.9335 -5.37764 -13.3979 -1398 6 20.8104 20.4092 13.7653 1.99296 11.0688 -14.7475 -1399 4 21.268 20.4545 14.5989 11.9976 -3.76106 7.6647 -1400 4 19.8959 20.3184 13.9984 -15.4264 -4.27358 -1.02469 -1401 6 20.3637 29.125 1.38742 -7.39452 3.20569 15.6829 -1402 4 20.6257 29.8678 1.97015 -13.6171 -7.9879 -3.97808 -1403 4 19.4728 28.7955 1.69287 22.5847 10.4694 -9.78123 -1404 6 50.8792 13.1212 37.2655 -4.22961 23.9091 37.9372 -1405 4 51.3893 12.5589 37.8771 -2.47029 4.54984 -9.0483 -1406 4 50.5869 13.8674 37.8656 5.03029 -21.5284 -25.2034 -1407 6 33.9282 34.1694 20.494 -12.758 16.9363 4.62304 -1408 4 33.9505 34.3661 19.5368 -1.52487 0.481952 13.5649 -1409 4 33.2327 34.7631 20.901 14.0918 -19.53 -17.3949 -1410 6 26.2111 28.0581 27.5584 -15.6012 -12.4051 -9.62147 -1411 4 26.6887 28.3319 28.3498 -5.67664 4.83839 -0.885474 -1412 4 25.2376 28.0657 27.7416 20.5709 -1.16679 -1.23567 -1413 6 7.682 21.3042 4.28531 -31.6563 9.11884 52.3302 -1414 4 8.36407 20.9023 3.81015 41.1991 -18.6864 -33.8238 -1415 4 7.19271 21.9105 3.74865 -6.01459 10.7978 -19.2095 -1416 6 22.0049 15.1615 5.91526 -5.59087 32.8095 7.59658 -1417 4 22.5291 15.4011 5.14076 -1.79158 -8.25489 -6.60562 -1418 4 21.8369 14.2416 6.04435 2.97447 -25.4321 -3.26552 -1419 6 21.7136 24.0096 3.8157 22.5859 -13.9702 -11.1371 -1420 4 22.6792 24.1846 3.95073 -20.2229 4.30251 2.28349 -1421 4 21.6957 23.2604 3.18041 -1.04284 4.75891 13.5064 -1422 6 11.5672 23.7812 12.5534 10.6653 17.5289 -0.525849 -1423 4 11.8567 24.7317 12.4283 -11.704 -31.033 2.93832 -1424 4 11.2483 23.6794 13.4494 -5.02459 5.94744 7.15157 -1425 6 32.3679 18.058 29.8144 -2.59991 12.5874 27.6023 -1426 4 33.2958 17.8537 29.9681 1.40206 -2.08885 -2.88861 -1427 4 32.1708 17.8352 28.9168 3.64727 -16.5589 -23.8097 -1428 6 9.27501 12.3901 30.3257 8.89695 -9.73537 -4.18026 -1429 4 8.97738 13.0169 30.9954 -4.04452 2.00113 -0.0309771 -1430 4 10.1278 12.0418 30.6776 -19.7256 9.24572 -11.0885 -1431 6 40.1671 25.9203 9.1352 -31.1658 -6.55029 4.71016 -1432 4 40.7952 25.2818 9.45931 8.36253 -10.0667 -0.250848 -1433 4 40.6474 26.7215 9.01492 17.3912 21.2934 -6.4579 -1434 6 43.1616 32.3487 37.3267 7.45809 -19.2286 11.3512 -1435 4 42.8399 32.8446 36.5586 -11.2032 -5.45956 10.184 -1436 4 42.4733 31.7245 37.6799 8.3011 17.0164 -20.2151 -1437 6 44.0911 6.28198 31.259 8.64406 -6.47735 -33.2401 -1438 4 43.4563 6.84482 31.6606 -21.1773 24.4303 10.8162 -1439 4 44.5952 5.92873 31.9644 15.9286 -14.2375 24.3689 -1440 6 10.2063 18.8787 19.6978 14.6089 -0.63771 -2.74842 -1441 4 10.128 18.3979 20.5267 6.04825 -4.13467 -1.20166 -1442 4 9.36891 19.3219 19.635 -15.0357 8.38504 -1.1225 -1443 6 7.0561 15.5922 15.0299 -16.4573 19.9198 -23.3889 -1444 4 7.18612 15.4783 14.0721 1.05096 2.95086 4.94392 -1445 4 7.41457 14.833 15.4354 13.8635 -34.6267 13.25 -1446 6 24.544 3.4899 27.8655 -14.5565 -8.97091 -7.81951 -1447 4 23.6823 3.28725 28.2588 1.61952 11.0081 14.175 -1448 4 24.3729 3.16547 26.9791 10.0044 -2.74415 -7.35546 -1449 6 54.4109 31.8087 9.71194 -6.99911 23.6955 33.3298 -1450 4 53.8413 31.5567 9.00593 -8.22136 -4.9258 -26.1741 -1451 4 54.0752 32.6964 9.97695 10.2913 -15.383 -7.59421 -1452 6 6.81072 17.0817 36.2069 -39.6649 -0.569341 -18.8672 -1453 4 5.9036 16.7161 36.0961 17.2423 3.35707 18.397 -1454 4 7.03883 17.1994 35.2786 19.8939 2.17194 6.76773 -1455 6 28.6373 7.46216 20.4204 -3.00228 3.72915 -26.9716 -1456 4 27.791 7.71165 20.8314 -1.23568 -3.59083 -7.19581 -1457 4 28.5788 7.67124 19.4449 -3.89686 1.20908 30.1283 -1458 6 17.0427 1.7136 8.36469 -7.39711 4.96373 -17.441 -1459 4 16.9511 0.79552 8.17539 8.34993 -30.6792 14.2707 -1460 4 16.7364 2.03503 7.50962 2.58977 23.9868 7.32556 -1461 6 19.1319 19.334 35.5748 25.2315 11.3156 3.71898 -1462 4 18.4163 18.7293 35.4559 -12.7574 -15.0058 -3.77114 -1463 4 19.9108 18.8059 35.8312 -7.49406 2.79856 2.97864 -1464 6 7.31044 31.3665 13.5876 -12.5896 -10.3186 -18.1643 -1465 4 6.86348 30.5057 13.838 5.41483 30.5465 -8.86898 -1466 4 6.71656 31.9291 13.023 7.05746 -22.9991 7.02109 -1467 6 16.6555 5.24573 12.8486 0.44122 -36.1931 20.2204 -1468 4 17.4189 5.79101 12.9112 23.6003 17.0932 2.01526 -1469 4 16.8511 4.45507 13.4194 -12.0332 11.5633 -21.5138 -1470 6 43.8917 12.7482 34.58 -33.2024 -13.6106 -1.45858 -1471 4 43.9807 13.5999 34.156 2.60816 15.5254 -0.13451 -1472 4 42.9242 12.5381 34.5161 22.3754 -3.96122 -2.5942 -1473 6 42.656 36.4522 28.5282 -7.17959 22.9727 1.13167 -1474 4 42.279 37.3416 28.6522 -7.55712 -15.8866 -0.526154 -1475 4 43.5285 36.675 28.2003 16.3904 -10.8581 0.329061 -1476 6 35.3704 15.0467 6.02622 35.7531 43.3754 17.6476 -1477 4 35.9258 15.8884 5.86958 -26.5611 -35.5954 0.991204 -1478 4 34.7923 14.9488 5.27074 -5.69332 -0.0870189 -10.0798 -1479 6 19.4034 5.85396 6.19026 -42.6676 -37.2433 -25.4755 -1480 4 18.4973 6.11578 6.46985 14.7962 -6.51198 7.73248 -1481 4 20.0178 6.47164 6.48735 29.6225 43.4574 23.1864 -1482 6 29.2636 38.16 6.98139 -51.0091 34.2659 0.167673 -1483 4 28.4794 38.0546 7.56687 16.6219 5.90534 -14.0005 -1484 4 29.8812 37.5458 7.29338 34.0617 -33.3732 10.6718 -1485 6 19.3639 26.1879 8.4772 -1.75021 -19.5484 18.4946 -1486 4 19.3765 25.7536 9.37133 0.505418 11.6152 -20.7618 -1487 4 20.132 25.8039 8.02679 -2.64689 1.58972 6.88257 -1488 6 4.91801 16.6546 6.12902 16.8332 -1.31437 8.04366 -1489 4 5.58152 17.3 5.84506 -6.45866 4.1219 -0.991793 -1490 4 5.39084 15.8022 6.09449 -7.75564 17.9483 -2.53018 -1491 6 6.07873 16.6931 28.0679 20.4204 4.35008 -35.2212 -1492 4 5.19925 16.4426 27.8453 -29.7482 -9.15572 9.47762 -1493 4 6.44387 16.7631 27.1426 -3.77999 2.92972 38.3228 -1494 6 21.7313 29.3584 22.0941 -19.989 26.599 40.0594 -1495 4 21.5191 30.3374 22.0902 3.30888 -28.6715 -0.0155919 -1496 4 21.2646 29.0087 22.9228 20.4195 8.84702 -28.341 -1497 6 24.487 0.545827 12.8459 24.5625 -19.0276 8.44191 -1498 4 24.0381 0.883409 12.0817 -9.22903 10.6064 -10.7293 -1499 4 24.0836 0.980384 13.5911 -6.14963 8.46579 8.44801 -1500 6 18.4109 28.2545 40.3162 -15.9129 36.5713 -32.2972 -1501 4 18.3366 27.7076 41.0573 0.952339 -31.6797 34.0712 -1502 4 19.1875 27.9677 39.8503 10.0284 -2.61836 -5.50219 -1503 6 10.3807 17.4604 21.8947 -1.20821 -16.3296 3.13877 -1504 4 9.80057 16.6779 21.8113 10.8468 3.86983 1.60142 -1505 4 10.0443 17.9356 22.6521 -9.33664 9.03137 6.2204 -1506 6 13.5404 13.3591 39.6327 12.5768 11.767 30.0264 -1507 4 13.9188 14.1992 39.2886 -9.97897 -11.5724 13.3172 -1508 4 13.5464 13.3749 40.6413 1.33606 5.90172 -38.0522 -1509 6 19.5508 26.0247 24.7387 -47.8665 -1.21537 -13.2845 -1510 4 19.6189 25.3328 24.097 -5.62542 -9.91951 -19.3965 -1511 4 20.3649 25.9852 25.1641 45.3739 3.88293 31.7071 -1512 6 8.93445 25.8823 20.0822 -10.4543 -29.9419 8.18251 -1513 4 8.35083 26.4773 20.5043 -33.2288 11.519 27.1484 -1514 4 9.504 26.5029 19.6962 43.6798 16.1155 -28.0388 -1515 6 13.4493 41.2138 30.5102 -4.84662 -36.1256 25.75 -1516 4 14.2597 41.094 31.0483 -5.58856 8.18726 -8.9115 -1517 4 12.8416 40.5025 30.8796 12.8197 27.661 -18.9522 -1518 6 21.1596 21.6794 11.1163 10.7366 20.8259 2.41134 -1519 4 20.9554 20.8709 10.6777 -10.2383 -24.5438 -10.817 -1520 4 21.2276 21.4421 12.046 -2.84377 -3.57945 5.82209 -1521 6 43.5643 10.3136 15.5616 17.5969 -21.741 5.94749 -1522 4 43.2379 9.48961 15.149 2.99942 14.1859 3.68588 -1523 4 42.9802 11.0242 15.3396 -21.8087 10.2132 -10.2755 -1524 6 23.5302 5.07333 12.3088 -23.5628 55.8128 -25.3063 -1525 4 23.4112 4.1923 12.0373 1.19089 -49.3933 -5.08619 -1526 4 23.0178 5.53904 11.5656 24.5614 -12.3881 30.382 -1527 6 9.28539 15.401 4.24759 1.63269 -5.62651 -9.8947 -1528 4 9.02922 16.1115 4.82738 -12.4128 14.4693 4.40189 -1529 4 9.90895 14.9318 4.78697 15.8319 -9.58935 3.85081 -1530 6 26.711 10.8797 17.566 5.43365 -10.3343 -26.0937 -1531 4 26.4818 11.0142 18.4585 -6.06422 3.32013 41.5711 -1532 4 26.8019 11.7518 17.1937 0.341074 3.88847 -5.26754 -1533 6 26.0592 23.5875 33.6794 25.1455 50.9154 21.2543 -1534 4 25.4682 24.0785 33.1024 -8.24785 -6.01089 -9.80751 -1535 4 26.6604 24.3213 34.0779 -26.6739 -38.162 -12.8336 -1536 6 7.57385 10.4949 28.9097 -14.7972 2.07126 0.456687 -1537 4 6.75277 10.5859 29.4011 -5.17598 -12.8295 -3.89358 -1538 4 8.06091 11.2035 29.3139 24.0536 5.38729 3.77373 -1539 6 16.4953 16.9073 24.6459 13.4535 22.6993 31.6086 -1540 4 15.9363 17.7011 24.6942 7.46422 -1.49957 -9.096 -1541 4 16.1467 16.4045 23.9375 -12.5815 -17.1437 -28.632 -1542 6 12.5505 12.7927 0.441559 26.7797 -18.4986 61.4448 -1543 4 12.8902 12.7839 1.42408 -16.6807 15.1369 -51.7767 -1544 4 12.972 11.9767 0.117581 -17.3776 3.59908 -10.4186 -1545 6 6.80454 2.46926 9.04378 10.3033 -16.1572 19.5551 -1546 4 7.05376 2.92505 9.85651 -1.04006 9.78535 -3.84035 -1547 4 7.36555 1.67892 9.06596 -6.07141 -1.3767 -9.09165 -1548 6 28.8788 11.8454 12.005 47.3119 33.3239 7.75537 -1549 4 28.2175 12.4307 11.6211 -4.89696 7.77957 0.00959457 -1550 4 29.7805 12.2922 11.8721 -37.0304 -14.6121 1.30522 -1551 6 44.6756 32.5924 29.7091 -46.8228 -4.47104 18.0754 -1552 4 43.7214 32.9254 29.5641 42.8383 -8.78111 -1.84094 -1553 4 44.558 31.8742 30.3802 4.31467 20.1075 -17.1439 -1554 6 28.6099 15.1189 32.288 -8.09168 -64.7739 -6.10589 -1555 4 29.0591 15.887 31.9855 13.2175 18.1439 -15.8441 -1556 4 29.0109 14.3064 31.825 -10.272 37.9041 18.9788 -1557 6 1.13952 22.1955 33.6303 -59.4889 25.247 28.7943 -1558 4 0.675447 22.8098 33.0333 5.4615 -9.68619 7.91413 -1559 4 1.8611 21.9185 33.1521 52.5767 -22.4691 -40.0321 -1560 6 17.4529 16.8222 9.92046 -20.0761 -24.0842 48.1247 -1561 4 17.9341 17.1517 9.19999 21.5054 13.464 -32.8219 -1562 4 17.9802 16.1035 10.3295 -2.40424 8.44812 -14.2536 -1563 6 18.74 29.8021 14.3918 16.1488 4.65404 69.9188 -1564 4 19.5966 29.6355 14.8679 -24.5899 1.22938 -11.6521 -1565 4 18.9027 29.6655 13.4911 13.4763 -5.12933 -46.2854 -1566 6 39.4106 6.51176 13.0171 8.18439 9.54271 -9.98348 -1567 4 39.7968 7.3217 12.6105 -7.82756 -18.4389 5.68309 -1568 4 39.8965 5.76959 12.6221 -1.11983 7.69721 6.02388 -1569 6 54.1122 38.2735 14.316 -26.3921 15.7841 23.5556 -1570 4 53.5092 38.7211 14.9446 14.1224 -15.8084 0.476194 -1571 4 53.7657 38.6747 13.5269 5.67525 0.359642 -25.5906 -1572 6 7.51656 32.0218 20.9281 34.7748 10.0158 34.1931 -1573 4 7.08362 31.9253 20.1193 -22.6959 2.07513 -43.8223 -1574 4 7.03544 31.4175 21.4603 -12.2713 -14.4046 24.4342 -1575 6 26.9722 15.5137 13.836 8.2831 -9.07996 -12.1546 -1576 4 27.2905 14.6773 14.2204 -10.3825 7.39938 7.42218 -1577 4 26.0228 15.629 13.9568 -6.27371 -3.74993 11.5294 -1578 6 18.3731 16.4369 32.1258 -5.47484 6.15837 -16.1574 -1579 4 18.1737 16.7054 31.2071 -0.945967 -8.38127 9.44724 -1580 4 19.0036 17.0959 32.4159 12.6478 4.85619 3.13766 -1581 6 52.4904 31.6749 23.2282 -45.8236 3.94874 65.5164 -1582 4 52.5054 32.2301 24.055 -6.11863 -14.7847 -21.5508 -1583 4 53.2278 31.9578 22.7624 44.676 11.2926 -39.5338 -1584 6 2.17063 9.69676 28.2025 -10.599 22.0242 17.0864 -1585 4 2.41083 10.574 27.888 12.6445 -0.15763 -12.1006 -1586 4 1.36653 9.91172 28.7063 1.66945 -10.1846 4.32482 -1587 6 32.9295 0.084333 22.579 -26.8721 -17.4052 -13.8633 -1588 4 33.2309 41.109 22.2818 0.690852 17.8844 8.89147 -1589 4 33.6446 0.598803 22.932 23.7791 -0.031599 0.0852179 -1590 6 20.7171 41.5453 38.643 51.9522 19.855 -62.1487 -1591 4 20.0643 41.0408 39.0691 -29.2365 -22.9372 13.5286 -1592 4 20.9788 41.0468 37.7869 -12.0924 18.2625 49.3819 -1593 6 43.2965 24.3242 12.1559 29.4143 27.7167 -28.3716 -1594 4 43.2964 25.2918 12.2975 -10.3211 -14.9579 7.88207 -1595 4 44.0244 24.2792 11.4826 -12.2932 -11.2644 22.4039 -1596 6 22.0333 36.2992 11.8143 -17.8744 11.1706 -5.23693 -1597 4 21.6038 36.9407 11.2131 12.0614 -9.84488 11.7859 -1598 4 22.8639 36.0559 11.3996 4.49067 -2.6397 -1.6843 -1599 6 50.7446 20.5307 30.3299 -19.4296 24.1009 0.394401 -1600 4 50.3769 20.0585 31.0978 -4.60399 -0.499453 -6.82258 -1601 4 50.1204 21.2977 30.1594 19.9431 -26.9935 4.34337 -1602 6 20.8379 3.84934 18.1872 -10.63 2.24574 17.9634 -1603 4 21.6372 4.15439 17.7675 6.81748 4.13844 -2.44268 -1604 4 20.7537 4.31685 19.0447 1.53322 -4.30004 -12.0579 -1605 6 4.001 20.6421 6.99361 -18.7611 -9.71733 3.72301 -1606 4 3.09723 20.6004 6.53941 30.5715 -8.65918 22.3858 -1607 4 4.00786 20.2035 7.89591 -15.2068 14.2544 -28.772 -1608 6 11.948 15.4413 41.4409 9.86263 -45.3449 -5.39948 -1609 4 11.9713 14.4541 41.6361 -2.32711 35.624 3.02695 -1610 4 12.4708 15.4889 40.6181 -5.28805 11.0492 6.42 -1611 6 3.00764 18.5435 38.9252 6.90717 -29.584 40.0663 -1612 4 3.56523 17.7255 38.8717 -9.75827 16.9893 -1.25399 -1613 4 2.92934 18.9138 38.0721 -1.66709 15.3109 -35.9518 -1614 6 8.5978 38.8858 11.3072 48.4025 32.5603 4.46589 -1615 4 9.44036 39.0024 10.7943 -20.5341 -1.07382 9.55064 -1616 4 8.19448 38.1327 10.9484 -22.3544 -46.6733 -17.9601 -1617 6 12.9691 33.9778 38.4933 34.8069 -13.3685 -21.4899 -1618 4 12.6573 33.2385 37.9471 -9.06758 1.22663 10.2849 -1619 4 13.9307 33.983 38.2659 -20.4066 10.3952 14.8996 -1620 6 4.69069 11.9902 6.04709 5.57568 0.955193 2.63183 -1621 4 3.83092 11.6207 5.79405 1.19943 -2.71585 -3.65246 -1622 4 5.36696 11.7708 5.36999 -19.9658 -4.94035 2.87891 -1623 6 10.8381 15.9154 25.2196 -36.4648 2.02786 -4.38258 -1624 4 11.7191 16.2167 25.3262 31.8449 11.9168 5.4517 -1625 4 10.3518 16.6682 24.8476 5.65772 -8.76316 -0.529027 -1626 6 20.7604 3.23767 6.55488 4.15603 28.9608 0.670607 -1627 4 20.2106 2.56517 6.18958 -7.79877 -24.0058 -5.45951 -1628 4 20.2434 4.04703 6.45055 -2.36445 1.41903 2.77062 -1629 6 47.6381 39.1588 31.2153 -11.506 28.7103 -40.9212 -1630 4 46.7125 39.0803 30.8864 16.1685 3.01672 12.9065 -1631 4 48.0161 39.883 30.6238 -10.851 -36.2784 24.6994 -1632 6 8.33868 27.7571 27.6932 -33.938 3.65348 13.4266 -1633 4 7.90796 26.9962 28.1436 6.90464 18.5991 -0.450451 -1634 4 9.05762 27.3551 27.2376 19.8804 -10.068 -12.1598 -1635 6 33.245 40.3099 33.4253 18.3517 22.2199 -28.9554 -1636 4 32.5937 41.0038 33.2194 0.94932 -12.4457 9.89811 -1637 4 33.9479 40.492 32.7526 -7.59275 -9.33057 17.0692 -1638 6 24.5058 34.6327 27.2588 -1.70215 14.4876 -27.3243 -1639 4 24.8356 35.5409 27.0166 -5.53884 -24.0927 13.0812 -1640 4 24.1351 34.315 26.3934 7.47117 3.95694 29.9195 -1641 6 13.3256 36.76 35.7403 23.371 22.3884 -21.319 -1642 4 14.292 36.6204 35.8687 -19.0607 -2.42845 14.454 -1643 4 12.8134 36.0651 36.1242 -8.79549 -23.1532 9.33092 -1644 6 34.0568 20.1616 33.2139 18.2744 1.49148 -3.34215 -1645 4 34.901 20.3965 32.7524 -27.9907 10.0382 9.43414 -1646 4 33.5726 20.9405 33.5892 13.555 -8.0917 -8.63642 -1647 6 22.8329 33.5616 31.6214 -12.6844 15.5573 -21.5595 -1648 4 23.5755 34.1858 31.5969 1.53708 -3.14405 -0.637663 -1649 4 23.0292 32.8658 32.2325 13.4469 -12.4025 17.113 -1650 6 23.7434 2.42786 19.8498 9.49596 22.5629 12.9133 -1651 4 24.532 1.90722 19.7117 15.1933 -8.07802 -2.32773 -1652 4 23.0629 1.99408 19.3682 -23.4605 -15.8437 -14.4607 -1653 6 10.59 1.63974 20.5169 -0.95575 -6.83071 6.14558 -1654 4 9.98705 1.03236 20.0473 7.71399 2.84727 3.14747 -1655 4 10.6246 2.47233 20.0276 -8.35822 1.7372 -3.87231 -1656 6 6.50082 24.8628 7.81243 5.63459 3.09475 -4.38693 -1657 4 7.40706 24.9537 7.44087 -14.825 -10.0154 1.3351 -1658 4 6.01351 24.1359 7.38457 10.3118 5.93376 -6.27471 -1659 6 54.7907 32.5298 25.4601 2.42441 14.1538 -12.299 -1660 4 54.0693 33.194 25.3949 12.697 -15.3913 -0.923548 -1661 4 0.387469 32.6052 24.6546 -22.4501 -0.197402 25.3904 -1662 6 6.24565 20.1804 28.9699 -20.0835 16.2671 13.5362 -1663 4 5.37616 20.2206 28.5173 17.3942 -4.89439 1.50138 -1664 4 6.85708 19.7029 28.4106 5.94408 -11.9876 -6.03836 -1665 6 50.061 21.6087 11.3404 -11.515 44.0552 -42.0488 -1666 4 50.9725 21.751 11.0493 2.56545 -3.3262 -1.97817 -1667 4 50.0662 20.9568 11.9903 8.13397 -42.2403 36.0281 -1668 6 43.4741 33.5215 19.648 39.1267 -7.16957 -40.9914 -1669 4 43.8052 33.5504 20.5247 -1.27694 2.64583 28.8889 -1670 4 42.5461 33.5822 19.6063 -36.855 5.29583 12.3512 -1671 6 30.8225 7.19458 41.0729 -33.0718 18.8928 10.1641 -1672 4 30.0173 7.64992 40.6345 32.3343 -18.9847 22.962 -1673 4 30.7853 7.47469 0.131591 -1.52838 -8.42988 -38.7943 -1674 6 12.1264 25.8478 11.0965 -41.5825 -1.76886 -24.0951 -1675 4 11.2804 25.9828 10.5746 22.2453 -8.09118 27.7312 -1676 4 12.6111 26.6214 10.8799 25.9351 22.819 -1.42381 -1677 6 47.8207 5.82713 17.7363 28.7614 -16.7343 -8.46055 -1678 4 48.0335 5.15295 17.0353 -2.74159 24.5551 13.4979 -1679 4 48.6986 6.12754 18.0988 -19.3132 -4.26463 -8.98138 -1680 6 35.1697 12.9074 16.5814 -26.6969 23.1645 14.7724 -1681 4 35.331 12.9801 17.5341 9.94288 -5.95548 -5.31324 -1682 4 34.5116 13.6489 16.4838 18.7069 -22.8028 -11.189 -1683 6 10.4746 10.6344 33.9856 -30.1195 -20.4446 -6.31426 -1684 4 10.7944 11.3866 34.5009 -4.55531 -6.56386 0.452866 -1685 4 9.59186 10.377 34.349 25.6427 10.4215 -3.60637 -1686 6 9.86976 7.46809 9.66723 13.2706 -15.2427 -11.6817 -1687 4 9.07254 8.00079 9.6953 0.322066 10.4083 -1.78771 -1688 4 10.1027 7.29929 8.72005 -15.6005 8.2826 19.6359 -1689 6 11.1498 9.5629 29.1446 -4.60031 -6.3451 3.75047 -1690 4 10.6862 9.26798 29.9509 5.10767 2.07156 -10.4371 -1691 4 11.3249 8.76682 28.6116 2.75639 0.845127 6.4689 -1692 6 46.3982 12.7571 37.8973 13.0728 8.65129 -14.0384 -1693 4 46.6651 13.0033 36.9771 -6.5436 -6.98702 17.4091 -1694 4 46.8422 13.384 38.4935 -4.33131 -5.25976 0.421567 -1695 6 4.7745 19.0249 15.9997 -22.3762 2.96494 22.3523 -1696 4 4.16029 19.0173 16.7572 4.82074 7.85299 -8.34635 -1697 4 5.51792 18.5695 16.4006 17.242 -3.98645 -13.636 -1698 6 50.2756 39.8187 19.3535 -48.7732 -19.7782 -8.19609 -1699 4 50.1357 39.0812 19.9713 14.3147 6.83039 4.1366 -1700 4 49.4547 39.7468 18.7938 35.5854 8.27631 5.22634 -1701 6 3.57022 23.2982 26.3116 -7.21736 12.7853 -4.33091 -1702 4 3.04677 23.327 25.4841 2.15403 -9.28995 15.8001 -1703 4 3.1589 23.9918 26.8774 3.27351 -16.4313 -7.87876 -1704 6 43.3323 18.2357 20.5099 -9.76971 -1.121 -6.56922 -1705 4 42.7632 18.9863 20.7177 2.34101 2.93749 0.115163 -1706 4 43.9096 18.122 21.2711 1.48233 -4.92166 7.17918 -1707 6 14.4939 41.5272 19.7194 7.33174 -3.95938 -8.98841 -1708 4 13.9791 41.768 20.4704 -25.804 7.49044 14.4407 -1709 4 15.35 41.4773 20.1189 24.9681 -5.23262 -6.74673 -1710 6 29.2751 29.8624 26.915 55.5011 14.3278 -64.7852 -1711 4 29.462 29.6739 25.9095 -28.0317 9.76644 54.5148 -1712 4 30.1137 30.3565 27.1616 -29.5885 -20.0698 8.89328 -1713 6 6.32585 26.1455 11.5441 3.18215 15.5722 27.8672 -1714 4 6.22913 25.7559 12.4173 -5.87839 -9.43723 6.04013 -1715 4 6.88652 26.9071 11.7431 3.72153 0.148286 -16.8953 -1716 6 27.6581 9.23325 15.2376 24.6795 20.4415 1.81178 -1717 4 28.3906 9.86787 14.9946 -20.7277 -22.2866 6.02651 -1718 4 27.7257 8.49599 14.6233 3.42822 -3.8556 -2.27597 -1719 6 29.7826 38.0629 17.0951 -21.7625 -1.10982 -31.3954 -1720 4 29.5447 37.2807 16.5438 11.5646 7.7876 16.1146 -1721 4 29.1666 38.7512 16.7768 9.10566 -6.75007 12.2127 -1722 6 52.2237 28.7307 4.26632 40.7154 12.5569 -19.536 -1723 4 53.094 28.6942 3.75761 -25.982 6.02481 23.1744 -1724 4 51.8384 27.8718 4.17524 -3.40498 -27.0863 -4.04919 -1725 6 17.1651 16.6761 6.10093 10.0081 29.999 -15.4838 -1726 4 17.0645 17.5224 6.60658 -3.46995 -23.4179 -4.25622 -1727 4 16.9429 15.9406 6.65512 -3.52922 -13.7209 19.1007 -1728 6 36.6584 7.55275 33.426 1.51046 -27.4434 34.6673 -1729 4 36.0562 7.00422 33.9909 9.38132 12.247 -13.9906 -1730 4 36.0891 7.78594 32.7139 -15.8398 12.8789 -25.2624 -1731 6 26.1693 3.13272 9.58463 26.4836 36.1065 -53.3475 -1732 4 26.5189 3.61335 10.3026 12.8321 10.8542 33.1136 -1733 4 25.6805 2.43597 9.90138 -37.6231 -51.1462 30.1839 -1734 6 1.19232 17.1076 33.1734 0.722887 26.1228 -9.87087 -1735 4 1.0219 17.7977 32.4875 3.44775 -13.3597 11.6369 -1736 4 0.89275 17.4757 34.0242 -0.842403 -4.58413 -3.86686 -1737 6 29.175 10.1805 5.37687 2.48705 -7.47299 -1.58449 -1738 4 28.5307 10.3443 6.0806 2.54341 -1.49901 -0.102048 -1739 4 29.6529 9.35261 5.56356 -13.9845 3.47491 -0.693848 -1740 6 9.21964 21.135 0.193729 30.6013 -8.57211 -16.2038 -1741 4 9.93935 20.7152 41.5745 -5.21063 7.9265 20.924 -1742 4 8.4582 20.7874 41.6647 -18.4316 -1.36421 1.54976 -1743 6 7.41915 26.897 34.8578 6.273 24.0322 40.4596 -1744 4 7.07209 27.1094 35.7714 11.2799 -9.18849 -34.7736 -1745 4 6.87885 26.1925 34.5434 -18.5272 -22.724 -11.5995 -1746 6 18.6237 10.1563 3.02822 -55.9716 37.9013 1.68891 -1747 4 17.9823 9.44023 2.87563 14.9297 4.34306 1.98909 -1748 4 18.009 10.9755 3.18254 40.8652 -32.8317 -2.61569 -1749 6 13.1455 21.2337 25.2154 -14.3081 5.93545 -14.9534 -1750 4 12.8153 21.6822 24.4216 9.6722 -4.26313 4.93127 -1751 4 12.7862 20.3541 25.1726 -3.49479 -14.4912 -0.313259 -1752 6 4.91031 24.4198 40.532 -13.7809 -26.5024 -53.169 -1753 4 5.65778 24.4539 41.0894 26.3299 12.2697 26.6549 -1754 4 5.26856 23.9753 39.7091 -18.4358 16.5303 24.5031 -1755 6 54.7198 6.2862 9.93073 18.558 2.67796 -18.7732 -1756 4 54.1336 6.00192 10.611 -15.308 -5.80798 23.6242 -1757 4 0.005563 7.17106 10.1764 0.43073 7.36928 5.10877 -1758 6 51.7604 16.6436 19.3877 -20.3234 -7.55047 -14.8495 -1759 4 51.6779 16.1639 18.5383 1.1676 14.9854 4.84802 -1760 4 52.2077 17.4816 19.2574 16.3674 3.30585 -9.00164 -1761 6 38.6218 2.96001 13.0988 15.7387 3.67705 55.5859 -1762 4 38.6299 3.43096 13.9849 -4.06073 -12.9308 -23.724 -1763 4 38.2169 3.56793 12.5083 -12.8186 19.7945 -24.9943 -1764 6 19.4471 35.7007 9.61167 2.35324 -8.95281 6.35471 -1765 4 18.8335 36.2871 9.19379 -17.9936 2.63552 -14.7984 -1766 4 18.9495 35.3837 10.3842 8.56204 6.47345 -9.11173 -1767 6 46.9457 37.6212 25.7021 -15.6754 4.57489 10.5165 -1768 4 47.0239 38.0262 24.8354 11.6036 -0.197794 -10.4287 -1769 4 47.7281 37.1166 25.9279 8.14222 -0.129186 -6.11913 -1770 6 20.0249 17.2708 14.7582 9.34392 -2.11639 -6.02108 -1771 4 19.1723 17.4786 15.1706 12.7461 -0.873648 3.80655 -1772 4 20.7009 17.0069 15.4035 -13.3418 2.74043 0.572405 -1773 6 24.7358 29.2923 3.78206 18.5642 -33.4808 -47.1325 -1774 4 24.7422 28.3915 3.3709 -13.1038 11.8323 28.3161 -1775 4 25.3506 29.6775 3.14782 -2.77927 21.1078 10.4189 -1776 6 3.43141 8.92567 6.82668 25.8011 -1.75535 29.9445 -1777 4 3.08486 8.82716 7.75964 16.0017 4.22665 -30.6726 -1778 4 4.42441 9.10783 6.89545 -42.5611 -5.30748 1.54274 -1779 6 17.4891 30.59 19.7026 37.1524 -11.5388 -6.241 -1780 4 18.4343 30.3591 19.4199 -38.2372 10.1448 10.4771 -1781 4 16.9657 29.7875 19.5831 -4.14236 3.18225 -9.29444 -1782 6 13.2748 16.1833 39.0603 8.39615 -10.6604 2.01333 -1783 4 13.778 16.9491 39.3364 8.93523 3.59341 7.63718 -1784 4 12.5498 16.5465 38.5646 -17.693 7.52452 -10.3405 -1785 6 23.8419 27.9652 11.5971 -29.0622 15.8949 5.8355 -1786 4 23.0433 27.5239 11.9581 15.8216 -1.64981 -8.50246 -1787 4 23.6687 28.8945 11.8451 9.38175 -9.8305 -3.59643 -1788 6 14.4582 24.411 21.2251 -13.2323 27.0215 19.0701 -1789 4 13.9163 25.2229 21.3861 13.2503 -9.35589 -12.2275 -1790 4 14.348 23.9323 22.0593 -1.27999 -3.95586 -5.82862 -1791 6 46.6209 15.1404 22.2877 -21.0909 8.30909 34.5316 -1792 4 45.8336 14.7024 21.9608 7.3328 -3.88381 -14.3297 -1793 4 47.2246 15.4169 21.6106 10.5055 -5.27886 -22.0515 -1794 6 19.1453 29.7169 11.8746 -27.0123 -18.8736 -35.9167 -1795 4 18.7667 30.5363 11.5796 10.8323 29.6783 4.39578 -1796 4 18.5214 29.1838 11.3275 23.3568 -13.7991 20.8336 -1797 6 36.9132 18.8016 27.615 -17.0652 -23.8487 30.8874 -1798 4 36.4034 18.4868 26.8464 6.26881 1.65463 6.80847 -1799 4 36.6041 18.1666 28.3506 10.215 31.7365 -33.4968 -1800 6 35.8839 17.5137 25.5036 -5.81764 30.7264 -16.7466 -1801 4 36.5665 17.9094 24.9 -10.7703 -22.5287 9.19997 -1802 4 35.9135 16.5474 25.44 8.68204 5.15754 -2.43364 -1803 6 8.04468 41.8981 31.5366 26.4021 9.77217 -3.38911 -1804 4 8.66886 41.284 31.9946 -24.4733 15.0027 -13.0466 -1805 4 8.60227 0.704634 31.1522 -11.4596 -14.2431 6.13083 -1806 6 31.7024 34.8356 17.9299 26.5575 -27.0845 -4.88708 -1807 4 32.6196 34.4986 17.7931 -22.3662 0.836155 -3.84042 -1808 4 31.9071 35.6664 18.3392 -5.09232 26.8034 6.09861 -1809 6 22.0993 41.0535 5.13739 10.0927 40.3608 -89.4928 -1810 4 22.1435 40.6782 5.94278 2.96748 -46.7441 88.004 -1811 4 22.8097 40.6452 4.60918 -8.49191 2.25551 6.5005 -1812 6 11.6188 5.17183 29.5438 -37.4391 -17.3681 45.4318 -1813 4 12.0782 4.3477 29.7115 12.4576 1.56532 -11.0695 -1814 4 10.8376 5.06958 30.1835 21.3256 14.0691 -33.8944 -1815 6 13.0142 9.45267 21.0738 -17.3871 -39.5803 -33.4019 -1816 4 13.648 9.91302 21.5572 37.1542 33.3127 26.6408 -1817 4 13.4951 8.71823 20.6397 -14.9934 11.5246 2.17133 -1818 6 12.4259 4.16416 0.171584 25.5917 58.0572 -18.9009 -1819 4 12.7038 3.75631 0.988868 -0.121161 -3.62646 8.37405 -1820 4 12.9914 5.02921 0.073462 -27.1162 -49.1387 2.0493 -1821 6 45.1548 14.6294 28.1056 43.5869 -15.7342 -2.79686 -1822 4 45.3799 14.9442 27.2254 -14.4652 2.82802 -6.08545 -1823 4 46.001 14.1543 28.294 -26.1128 6.03561 5.66217 -1824 6 52.5819 19.2522 0.880939 -13.6546 -24.4625 3.21793 -1825 4 52.4967 19.3157 41.8353 6.16951 -6.72877 -2.3034 -1826 4 52.7342 20.1258 1.1855 8.55196 28.2584 6.16427 -1827 6 0.17636 18.5769 30.5692 -13.5341 -21.3209 11.3545 -1828 4 0.97347 18.6538 30.0344 3.16555 8.74201 -0.550561 -1829 4 54.7381 19.4288 30.6755 1.51483 11.9419 -1.05075 -1830 6 17.6474 28.1849 1.96582 -3.95698 7.79984 2.09024 -1831 4 17.0036 28.8884 1.72628 7.01161 -11.1903 7.18073 -1832 4 17.5665 28.0879 2.93205 1.48476 5.36119 -8.9874 -1833 6 22.5179 30.1562 5.01973 -0.557011 13.5756 -11.2394 -1834 4 23.053 30.1464 4.21842 7.71181 1.56353 5.86697 -1835 4 22.1417 29.2826 4.9966 -11.5089 -8.75783 6.0437 -1836 6 11.3992 8.80614 17.6425 18.8049 17.2909 -5.92301 -1837 4 12.0044 8.1818 18.0403 -8.94801 -14.7479 17.6102 -1838 4 12.0653 9.44286 17.3244 -18.8797 1.15675 -4.46111 -1839 6 32.2825 3.5901 26.8335 38.6865 42.7422 0.354813 -1840 4 31.9744 3.38447 25.9652 -16.937 -9.17442 -22.5821 -1841 4 32.8531 4.41036 26.697 -18.7333 -32.0278 -1.10411 -1842 6 26.8283 37.1448 15.664 9.9544 44.9512 -6.81835 -1843 4 26.832 37.6522 16.5019 -4.80771 -22.2764 -7.00776 -1844 4 26.708 36.2069 15.7377 -4.77442 -21.1488 11.5765 -1845 6 22.9466 3.40402 22.281 26.551 -3.46013 -1.27592 -1846 4 23.3626 3.00539 21.4748 -15.0613 6.75 14.6032 -1847 4 23.702 3.67884 22.8406 -14.5661 -4.86975 -12.1571 -1848 6 14.6187 28.2219 5.2011 12.2375 -1.31522 5.54773 -1849 4 14.146 28.1316 4.37141 -5.71124 1.87741 -8.30492 -1850 4 14.2863 29.0052 5.66137 -0.824291 -0.470469 -2.06805 -1851 6 20.2555 37.1856 16.5486 -24.9193 16.4856 21.7008 -1852 4 21.0596 37.4718 16.144 26.6499 6.5165 -11.4453 -1853 4 20.1477 37.8155 17.2956 -4.48599 -12.7862 -6.90992 -1854 6 17.9469 28.5629 23.8891 26.0841 -15.2841 -12.8531 -1855 4 18.7956 28.2639 23.4837 -20.5944 5.95667 14.8805 -1856 4 17.3322 27.8283 23.7208 -3.07308 9.52654 -1.59768 -1857 6 33.6454 24.2344 25.2281 6.08515 -19.3492 9.67379 -1858 4 33.7229 23.2583 25.1621 -7.7165 13.5894 -11.682 -1859 4 33.9838 24.3464 26.1231 0.527101 9.69022 -3.14208 -1860 6 9.99248 17.6305 2.22889 -2.94775 -31.1618 -12.577 -1861 4 10.7668 17.5307 1.6348 -7.17319 1.58445 12.7603 -1862 4 9.8062 16.7546 2.64219 6.61617 15.6433 -4.64734 -1863 6 24.3378 36.7975 8.92134 10.0949 -17.5556 18.6285 -1864 4 24.0798 37.5812 8.46711 -7.4438 24.0622 -5.98172 -1865 4 24.7733 37.0584 9.7453 -6.84359 -4.10885 -5.58351 -1866 6 14.3929 4.30304 27.7402 56.7365 -3.53996 19.7179 -1867 4 15.3546 4.44499 27.4586 -37.3153 -7.57895 7.00929 -1868 4 13.8272 4.37832 26.9899 -16.116 5.01688 -19.8092 -1869 6 13.2096 25.4586 35.3298 -3.87145 -6.51473 -10.8119 -1870 4 13.1476 25.2267 36.278 -1.83966 -3.78777 -13.8323 -1871 4 12.5545 24.9939 34.7684 5.09589 5.85633 19.2997 -1872 6 43.7315 33.1816 24.4051 17.2004 -9.02075 24.8986 -1873 4 44.3591 33.0681 25.1678 -20.1541 -6.26738 -17.3644 -1874 4 44.1096 33.9146 23.9227 -1.6352 8.32092 -8.69406 -1875 6 6.97009 30.4077 7.13769 23.121 1.43384 34.0809 -1876 4 6.71282 29.9591 7.9596 7.06976 3.62274 -2.26904 -1877 4 6.20421 30.2819 6.61977 -27.9511 -2.76807 -27.2062 -1878 6 44.437 39.4145 21.7835 -9.43682 11.6365 -18.5611 -1879 4 43.878 39.1032 21.0489 1.92512 -11.9494 17.5009 -1880 4 44.878 40.1639 21.3648 8.44417 -6.89071 6.17346 -1881 6 1.1648 16.4475 24.9778 -2.61131 5.39938 13.1681 -1882 4 1.07525 17.0286 24.1819 -7.88043 -13.0173 22.3573 -1883 4 0.434843 16.5677 25.6378 18.4556 1.9359 -28.7216 -1884 6 8.16988 33.8361 10.6637 16.6829 23.9256 47.7562 -1885 4 8.49559 33.5478 9.83195 -4.50358 -22.2449 -29.7436 -1886 4 7.35799 33.4028 10.9227 -18.4601 -13.1254 -8.86092 -1887 6 45.3716 15.8699 40.491 -6.36942 -3.03704 -2.15917 -1888 4 44.5133 15.7719 40.0601 4.63234 -6.98635 -0.416374 -1889 4 45.243 16.6248 41.0649 5.7116 1.92459 5.42472 -1890 6 38.7776 4.29245 15.9056 11.0795 0.30753 4.41463 -1891 4 39.6766 4.00679 16.0952 1.69097 -2.92337 -3.33067 -1892 4 38.5504 4.73291 16.7401 -7.14778 -2.92142 -9.36231 -1893 6 21.0846 9.20759 23.9691 5.60032 -0.18462 4.18544 -1894 4 20.9445 8.65571 23.1711 -3.69603 16.8592 7.46004 -1895 4 20.5672 10.0363 23.9442 1.93643 -14.5945 -11.3561 -1896 6 6.46938 36.1391 20.0069 4.0004 4.10087 4.13062 -1897 4 5.99357 35.3124 19.8297 -2.3473 7.0562 -2.30419 -1898 4 7.3052 35.893 20.4098 -0.600933 -5.92452 -3.30983 -1899 6 17.7588 23.4635 11.2444 16.528 -28.2646 53.7307 -1900 4 16.9432 23.8548 11.0264 -32.805 26.4079 -23.7501 -1901 4 17.621 23.3206 12.2167 9.32529 -0.814156 -28.2078 -1902 6 2.23938 39.2705 23.5372 32.4488 -19.3396 -21.3039 -1903 4 2.96143 39.1072 24.212 -19.8533 -4.03587 -26.9428 -1904 4 2.57592 39.0525 22.6024 -11.4643 11.6849 46.2914 -1905 6 21.7189 10.3135 3.08585 -2.90529 19.7604 61.578 -1906 4 21.843 10.1221 2.19424 -0.974385 -17.6276 -55.1642 -1907 4 20.7734 10.4085 3.28686 2.80557 -4.86174 -11.6796 -1908 6 13.3371 37.6485 26.8148 34.7445 -2.08205 -3.58175 -1909 4 12.7942 37.01 27.2655 -5.666 -15.7112 8.11946 -1910 4 14.1995 37.1812 26.5945 -31.1056 12.6209 6.4215 -1911 6 45.679 9.86525 8.82671 -1.22844 -5.97168 -0.0165319 -1912 4 45.3204 9.57969 7.98479 1.29945 7.51218 -9.52666 -1913 4 45.2548 9.27624 9.44517 -6.37871 -3.09075 9.62419 -1914 6 39.8117 32.343 29.5858 -3.04799 14.0722 -9.88422 -1915 4 39.6223 31.4471 29.2796 3.58631 -7.81261 7.71305 -1916 4 40.3439 32.3214 30.3816 0.770365 -10.1242 2.16071 -1917 6 39.1301 32.1592 8.96473 45.9624 -7.76569 -23.2306 -1918 4 39.6852 32.0596 8.1252 -31.4186 4.60772 35.1501 -1919 4 38.2007 32.2042 8.75798 -9.66602 0.778467 -8.76952 -1920 6 29.7501 11.3103 40.3404 42.6438 -12.6008 -10.1865 -1921 4 29.0692 10.6634 40.5326 -1.99158 -8.72077 -0.363163 -1922 4 30.6164 10.7842 40.3158 -34.6338 15.486 -0.0451708 -1923 6 24.8345 19.8801 29.8412 -7.59088 37.7695 16.0848 -1924 4 24.9026 19.0378 30.268 -1.65451 -21.4471 9.48031 -1925 4 24.5694 20.5293 30.547 8.64688 -23.6335 -15.2845 -1926 6 50.0799 29.4689 2.86832 11.3398 7.37373 -14.0975 -1927 4 50.7937 29.3382 3.51213 -5.95266 6.62042 -8.33887 -1928 4 50.5172 29.4209 1.98721 -16.9062 -3.16045 21.5768 -1929 6 26.3158 13.2487 37.9516 44.6834 6.62304 1.7852 -1930 4 27.2667 13.2121 37.7291 -19.4356 -10.4808 -19.3263 -1931 4 26.4654 13.336 38.8817 -25.2145 10.5198 25.1195 -1932 6 24.3285 13.817 16.1492 -2.87417 -29.0242 -9.8062 -1933 4 24.8278 14.0306 16.9324 2.95884 13.8503 11.1204 -1934 4 24.1796 14.5912 15.6032 1.91347 13.6823 2.96602 -1935 6 21.9624 25.0824 8.00452 15.4008 12.078 14.6814 -1936 4 22.598 25.7039 7.58094 -6.50256 -15.9793 3.04336 -1937 4 22.4506 24.6482 8.74092 -7.92214 9.81208 -17.5113 -1938 6 50.1646 25.295 29.0323 7.20414 -13.325 -13.2678 -1939 4 50.9752 25.188 28.522 -3.46618 -9.57224 -11.582 -1940 4 50.4808 25.9292 29.6536 -4.58067 20.151 23.6328 -1941 6 23.186 6.81871 7.63171 8.52809 43.4321 -4.70249 -1942 4 24.005 7.36604 7.81791 -26.2659 -19.6382 -4.15731 -1943 4 22.4749 7.49932 7.50679 12.9101 -23.886 0.0924589 -1944 6 6.93738 5.85096 20.8328 -1.25739 23.0019 -5.42089 -1945 4 7.49016 6.65136 20.6793 -8.05782 -22.0664 2.33926 -1946 4 6.43567 5.73489 20.0135 6.68134 -11.6114 -0.0369962 -1947 6 25.4027 39.7503 23.9523 -6.31967 32.2782 -31.5462 -1948 4 25.6215 38.8259 24.0292 3.86532 -10.8289 -5.32001 -1949 4 25.5293 40.0494 22.9984 1.78505 -20.5244 33.6821 -1950 6 10.8465 30.682 2.12076 -14.9417 -4.95607 29.3443 -1951 4 9.91334 30.8811 2.27771 3.65307 -4.25506 9.47201 -1952 4 11.0492 31.2188 1.38489 10.4343 12.2811 -36.8692 -1953 6 23.0846 40.5263 40.0577 -14.1833 12.856 -13.2149 -1954 4 23.7732 40.7716 39.4116 -4.4893 -4.99974 3.24897 -1955 4 22.2685 41.0049 39.7737 14.5189 -12.3092 -2.05606 -1956 6 29.2062 28.3669 37.5673 -46.9973 46.4688 -26.4511 -1957 4 28.2092 28.447 37.3765 47.4284 -5.55714 9.99444 -1958 4 29.3363 27.5265 37.9547 9.31284 -31.0764 15.334 -1959 6 1.86163 12.1711 18.0765 -5.91003 5.49035 -5.71632 -1960 4 2.55659 11.9166 18.6527 25.6221 -14.4574 8.12849 -1961 4 1.26079 12.5379 18.7153 -20.6967 6.08864 -3.03965 -1962 6 35.8475 14.1052 8.57203 -21.6385 -0.893463 -33.3774 -1963 4 35.1968 13.4152 8.63145 -9.00219 -13.9675 31.2536 -1964 4 35.5915 14.3843 7.67264 23.8052 12.2531 2.11843 -1965 6 9.47935 39.8135 37.5891 59.0759 6.31763 -30.1219 -1966 4 10.4266 39.6693 37.2666 -35.8633 -8.68454 26.4626 -1967 4 9.26489 40.5592 37.0217 -20.4655 -4.29881 5.22341 -1968 6 3.55142 30.3339 19.2713 -4.86381 -1.52132 15.3498 -1969 4 4.33638 30.9045 19.2209 2.57405 -7.87202 3.73908 -1970 4 3.61239 29.7873 20.0935 6.99099 14.0083 -17.3235 -1971 6 36.3358 32.3745 17.56 -88.747 -21.2483 -18.3477 -1972 4 37.1123 32.7301 17.855 71.5568 29.0637 22.2427 -1973 4 36.4955 31.7908 16.8209 7.92507 -6.87638 -5.35096 -1974 6 22.0663 24.5107 41.4102 10.2987 16.3962 12.7497 -1975 4 21.8202 25.2352 0.099599 7.35269 -2.74787 -1.24985 -1976 4 21.4331 24.5495 40.7007 -15.7672 -0.145359 -12.6123 -1977 6 45.7559 15.6146 11.6534 9.54961 -0.52573 -11.8143 -1978 4 46.6616 15.9476 11.7359 -2.85604 3.39399 3.95489 -1979 4 45.8337 14.6574 11.6049 5.18085 -12.4794 -2.56515 -1980 6 22.3677 20.3608 16.0248 -8.43349 0.762232 -3.33301 -1981 4 21.8453 20.4382 16.8206 -16.1556 -9.64869 10.2413 -1982 4 23.0114 21.0388 16.1556 20.3116 20.3082 3.24798 -1983 6 25.8272 25.7408 18.9039 -4.38174 23.1082 -8.64826 -1984 4 25.2526 26.4897 18.6396 10.1677 -11.9346 2.39614 -1985 4 25.327 25.3554 19.6213 -1.60311 -10.6753 3.35926 -1986 6 35.3217 34.2027 33.2895 -15.2368 -41.9721 4.95923 -1987 4 35.4982 35.1152 33.2737 3.10328 43.0158 -1.14622 -1988 4 34.4946 34.1251 33.8 0.780353 -3.85018 -10.6306 -1989 6 39.2773 17.1161 17.3873 -13.1248 -32.2738 -8.05101 -1990 4 39.9918 17.6798 17.5739 28.094 23.6652 8.23643 -1991 4 38.688 17.6273 16.829 -11.1713 3.07886 5.75329 -1992 6 0.390078 14.9382 21.7871 11.1367 4.76555 -0.935352 -1993 4 54.4387 14.8735 21.5807 -4.47162 2.48431 -1.07762 -1994 4 0.539841 14.2564 22.4568 -0.558284 -6.24417 -4.29591 -1995 6 15.9777 23.2264 17.7728 8.65625 13.1041 -6.34263 -1996 4 15.4566 22.9884 16.9791 5.52796 1.00784 5.82867 -1997 4 16.2806 24.159 17.6616 -10.6082 -13.1932 5.11686 -1998 6 5.23931 11.1231 17.5575 35.8701 -10.5445 17.9772 -1999 4 4.9182 10.2425 17.6538 -30.0926 -10.858 -8.95801 -2000 4 6.0864 10.9521 18.0214 -7.64643 27.0942 -5.06777 -2001 6 9.32885 36.7248 13.2722 18.9931 -22.2768 -8.23823 -2002 4 9.60165 35.7781 13.2295 -3.69965 14.6724 -0.704445 -2003 4 9.76236 37.1699 12.5317 -7.58045 -2.70049 0.515103 -2004 6 25.4778 33.5648 0.584885 -10.5355 67.2754 -12.4068 -2005 4 25.5984 34.5208 0.879361 -11.6997 -30.6233 -9.64051 -2006 4 26.086 33.1118 1.1181 20.4991 -31.2317 29.3626 -2007 6 17.3118 24.383 31.3319 -1.28664 6.54307 -2.76395 -2008 4 17.7194 25.1777 30.9449 -5.40799 -4.17061 0.343513 -2009 4 16.6541 24.6578 31.9842 -4.89885 3.77294 -0.581941 -2010 6 50.5608 32.7082 27.7934 4.54158 -2.94952 -18.7634 -2011 4 50.7453 32.9177 28.6973 0.494052 11.2961 18.8161 -2012 4 49.6536 32.9735 27.676 -15.0266 -0.0998574 -2.84245 -2013 6 2.26734 37.236 16.1173 -6.42813 -12.7591 -21.9136 -2014 4 3.23226 37.3187 16.1136 -7.03488 -2.64717 4.42174 -2015 4 1.90002 37.4962 16.9584 8.86323 8.39289 12.7736 -2016 6 25.781 33.1953 8.40059 -29.5389 -21.3471 9.61313 -2017 4 24.912 33.1588 8.86731 13.6407 4.32372 -10.5279 -2018 4 25.7521 32.4014 7.84509 3.14784 4.30114 -1.53431 -2019 6 24.7803 7.83271 25.42 33.5144 32.018 13.9598 -2020 4 25.5535 8.29724 25.0002 -28.4293 -10.6828 16.5011 -2021 4 24.3491 7.42211 24.7041 -24.9556 -17.4551 -27.4815 -2022 6 44.0168 27.3303 21.5604 -2.1935 -26.0293 -25.9567 -2023 4 43.1804 27.7287 21.7105 -15.5436 25.6402 11.6584 -2024 4 43.7182 26.5374 21.0766 16.4483 6.01939 6.04345 -2025 6 20.8314 32.075 6.72772 34.1297 -23.9008 -4.85338 -2026 4 21.613 31.4679 6.7544 -19.7741 14.5872 -14.4381 -2027 4 20.6476 32.1788 7.6576 -7.69651 14.1485 11.3249 -2028 6 0.619789 26.0994 3.99415 -10.3518 14.1264 10.767 -2029 4 0.887335 25.4928 3.30986 5.36048 -13.1936 -7.97543 -2030 4 1.24971 25.9998 4.71308 0.85353 -1.82089 -1.56654 -2031 6 23.69 0.227417 22.8544 35.0871 1.11343 17.3571 -2032 4 23.3906 1.11513 23.0752 -8.28129 -2.57498 -6.74336 -2033 4 24.6181 0.214091 23.2237 -29.0994 -2.98435 -11.3486 -2034 6 35.6339 26.9438 6.46453 10.8918 50.3879 3.14258 -2035 4 36.2586 27.0344 7.19591 -3.09793 -24.7425 -0.485193 -2036 4 35.6905 27.8753 6.10871 -13.1004 -35.3011 6.52721 -2037 6 50.1792 7.09321 18.6927 -10.3798 0.485236 0.91939 -2038 4 50.7755 7.39768 17.9917 2.23399 -7.26744 -1.07457 -2039 4 49.6856 7.89728 18.8977 2.66313 1.30029 -2.34319 -2040 6 12.4725 14.8259 12.1994 -11.4238 -12.6169 14.8051 -2041 4 11.6664 14.488 12.6556 18.5487 5.78377 -7.93059 -2042 4 12.1518 15.362 11.4889 -6.75978 6.85562 -13.2996 -2043 6 52.4644 22.357 36.3266 1.29806 9.96622 10.4358 -2044 4 51.6029 21.898 36.3064 11.3287 0.910024 -15.7837 -2045 4 53.0734 22.0059 35.6434 -17.6122 -2.36697 5.80151 -2046 6 41.7741 11.4843 39.1248 -4.39753 -8.31887 -97.8346 -2047 4 42.1028 11.6824 39.9378 27.3537 17.7413 77.2645 -2048 4 42.4804 11.7867 38.4877 -22.5072 -9.73773 16.9601 -2049 6 13.8016 22.5118 39.1095 -61.9889 -17.7515 -30.6487 -2050 4 12.8197 22.2903 39.2632 45.6803 12.2331 1.0283 -2051 4 13.898 22.318 38.1378 10.5436 5.15112 27.5343 -2052 6 28.757 19.5278 21.8422 22.1809 -34.574 6.30338 -2053 4 29.5381 18.8977 21.7155 -30.335 22.4331 6.48321 -2054 4 28.5907 19.9346 20.9925 4.65837 4.37905 -10.6157 -2055 6 8.3499 21.6369 36.3971 -4.18721 -6.14707 -6.4426 -2056 4 8.67403 22.5346 36.3601 -3.60933 11.4321 4.1017 -2057 4 7.70004 21.5677 37.1222 1.54916 7.87236 -6.53046 -2058 6 39.9526 23.9745 15.2115 13.6309 -13.3423 -31.903 -2059 4 40.8439 23.5703 15.3899 -24.3155 14.8143 -11.3375 -2060 4 39.7878 23.9253 14.2154 4.70535 3.62281 36.021 -2061 6 8.1527 38.6897 22.5283 9.69445 13.3876 41.2978 -2062 4 7.76273 39.4363 22.0797 -11.7526 5.15604 -12.9046 -2063 4 8.4358 39.1168 23.3873 -5.25998 -17.8667 -18.7912 -2064 6 10.8496 20.1728 28.9641 16.4592 -1.26099 15.6701 -2065 4 9.98954 19.7606 29.0198 -7.88942 -4.93169 1.40711 -2066 4 10.9743 20.477 28.0788 -3.54014 6.836 -18.3013 -2067 6 36.8958 23.8215 41.8184 -11.2791 50.4956 -15.8947 -2068 4 37.6092 23.2626 0.106032 31.5333 -36.7229 14.8491 -2069 4 36.0533 23.398 41.8576 -15.1401 -19.7994 6.87638 -2070 6 23.7844 40.6753 33.3645 25.4398 -8.90266 -26.6636 -2071 4 23.0047 40.9559 33.8219 -17.4738 3.31201 10.6553 -2072 4 23.8864 39.707 33.5122 -4.88896 17.7845 5.86364 -2073 6 4.67086 19.2968 35.4027 23.2175 14.2952 24.1117 -2074 4 5.52557 19.1329 35.8895 -25.1286 -0.194605 -14.6261 -2075 4 4.47498 18.5363 34.8535 5.06934 -11.7578 -4.1199 -2076 6 9.45318 25.7818 10.8943 -12.0967 -8.54473 -2.48434 -2077 4 9.17249 24.8577 10.8042 5.18757 -1.88658 7.00696 -2078 4 8.69489 26.2739 10.5541 4.04726 3.8113 4.64502 -2079 6 27.2856 22.4903 13.6084 -4.27813 -9.26261 -11.4963 -2080 4 27.1477 21.7546 14.2243 0.799228 0.372191 -1.31996 -2081 4 27.4324 22.0688 12.7356 2.14896 10.5831 15.5277 -2082 6 41.0369 18.7679 23.2817 21.3973 -17.1333 -11.6606 -2083 4 40.4805 18.1775 22.7581 -1.93352 7.79722 7.02989 -2084 4 40.5302 19.4817 23.6332 -16.07 12.1618 6.58845 -2085 6 46.4867 28.3511 20.139 19.5633 -2.73425 79.1757 -2086 4 45.7489 28.0125 20.7058 1.11057 9.83041 -23.9354 -2087 4 47.2126 28.3766 20.859 -22.6454 6.05643 -47.0217 -2088 6 14.8422 15.3983 30.0672 9.57922 -13.7488 21.5316 -2089 4 14.7114 15.4303 29.1407 -5.18406 2.12307 -31.6519 -2090 4 14.4223 14.5569 30.327 1.67929 11.6926 7.32181 -2091 6 23.5155 24.7614 35.2027 10.8097 10.1661 11.7756 -2092 4 22.8249 25.3921 35.4883 8.74662 -8.07224 -2.50931 -2093 4 24.264 24.8574 35.8273 -14.1502 1.20627 0.95778 -2094 6 19.9045 24.2066 28.4368 -7.08314 38.6572 -15.5481 -2095 4 20.1199 25.09 27.9887 -7.53461 -31.417 18.3002 -2096 4 18.948 24.2479 28.615 8.77669 -1.27719 -1.90381 -2097 6 45.9703 7.63062 20.2339 -9.12647 -14.8446 45.7383 -2098 4 46.0314 7.87281 21.2057 4.66889 -10.1155 -32.2433 -2099 4 46.2124 8.39508 19.7344 6.23892 21.3693 -9.48098 -2100 6 38.0366 12.4686 8.28298 -82.8488 23.4696 -21.0017 -2101 4 37.3097 13.1608 8.47894 48.7672 -25.4087 1.47773 -2102 4 37.4891 11.9231 7.63396 42.6716 2.94367 19.7224 -2103 6 46.9352 18.181 8.45984 -29.3266 9.95329 16.0714 -2104 4 46.1825 17.5598 8.49993 9.84889 1.25457 2.04897 -2105 4 47.3911 17.9594 7.65971 14.7535 -7.6497 -21.4463 -2106 6 10.8592 13.9727 9.37152 -3.14543 -2.30259 -2.26695 -2107 4 10.3309 14.6626 8.91794 11.6563 -8.1882 2.6931 -2108 4 11.7607 13.9013 8.99546 -12.5287 13.781 2.06755 -2109 6 34.3902 5.43491 14.0826 12.6346 -17.837 -1.14204 -2110 4 35.1666 5.80709 13.6695 9.45544 21.1547 -1.41353 -2111 4 34.3397 4.58795 13.6148 -10.7305 -5.41844 9.88093 -2112 6 0.19016 0.223418 22.9526 3.77382 -24.7853 -3.01602 -2113 4 0.21308 41.6498 22.1069 2.59646 7.80057 12.2766 -2114 4 54.882 1.08863 22.7473 -12.4607 27.7599 -7.08256 -2115 6 40.9349 30.5562 37.8906 -27.573 -19.5948 34.9696 -2116 4 40.0494 30.8463 38.2359 23.4276 0.414778 -20.0189 -2117 4 41.1198 29.7844 38.4793 13.2677 19.1991 -19.1849 -2118 6 16.6358 17.3088 12.6818 26.7235 26.3695 -9.20965 -2119 4 16.2617 16.4703 12.4231 -8.92935 -8.7699 -0.695474 -2120 4 17.0088 17.6771 11.8494 -7.35458 -7.68048 15.4997 -2121 6 29.681 5.43286 24.7605 9.99716 1.48249 -7.0405 -2122 4 30.3348 5.91815 24.2382 -0.696307 0.629534 -2.6419 -2123 4 30.0075 5.55596 25.6632 -4.07672 -1.78023 1.29455 -2124 6 49.8902 0.287541 27.2058 21.9743 -13.7053 4.20571 -2125 4 49.8511 0.519591 26.2742 -5.37584 5.48457 -4.26768 -2126 4 50.7946 41.8257 27.2858 -12.157 4.98657 1.57708 -2127 6 31.2412 31.7366 15.2127 13.4193 29.9729 -4.01619 -2128 4 31.644 30.8863 15.3566 3.05611 -13.2507 6.82249 -2129 4 31.9953 32.37 15.1128 -22.0385 -12.9049 3.52444 -2130 6 35.7903 24.1511 16.9464 13.6459 1.10276 -6.74723 -2131 4 35.6731 24.9832 16.4455 1.01595 -13.8109 1.97492 -2132 4 36.7089 23.8312 16.7527 -22.9866 2.97508 8.81266 -2133 6 24.2751 4.63968 36.7374 -16.5997 -22.3051 -33.4925 -2134 4 24.7608 5.22686 37.2962 14.6544 10.0168 10.4919 -2135 4 24.7016 4.68474 35.8573 -7.94113 -0.389021 16.9181 -2136 6 17.5636 12.9031 3.65869 27.6744 1.86844 -28.0383 -2137 4 17.6858 13.5605 2.94059 1.9993 -16.4932 11.4828 -2138 4 16.8984 13.3068 4.18363 -27.8054 1.98581 18.3397 -2139 6 4.17446 14.2934 18.2709 12.2351 -24.5699 -15.5283 -2140 4 4.25201 13.3082 18.1842 -5.45348 23.7329 4.34334 -2141 4 3.28482 14.5076 18.5604 -13.4286 -3.54266 5.37394 -2142 6 19.1793 36.8557 22.3908 -6.26797 4.12828 -2.16449 -2143 4 18.7803 36.3059 23.064 -4.74301 -7.71326 18.3965 -2144 4 19.5341 36.2254 21.7686 7.87239 -11.0625 -9.31555 -2145 6 15.659 11.9578 13.1999 9.98626 24.0921 3.91449 -2146 4 15.6233 12.8387 12.7526 3.08695 -23.3335 12.0049 -2147 4 16.532 11.8904 13.6603 -13.5492 -1.68197 -15.0215 -2148 6 24.7583 21.9129 5.36621 -52.0449 4.43235 28.4012 -2149 4 24.9756 21.6947 6.28233 10.5491 3.37037 -1.58044 -2150 4 23.7611 21.9216 5.43181 35.5612 -5.35731 -13.8865 -2151 6 52.741 18.5708 35.2268 19.1809 2.02674 5.12186 -2152 4 52.5591 18.101 34.4104 -23.468 -7.47943 -3.72799 -2153 4 51.9957 18.6447 35.8177 -20.5936 -5.49273 0.0575333 -2154 6 3.56038 27.2788 25.2921 -16.6903 -17.6792 -11.4043 -2155 4 3.96469 27.2185 26.149 7.10467 -3.13705 18.347 -2156 4 3.97939 27.9962 24.8424 10.8751 21.6711 -8.62461 -2157 6 34.4448 32.9974 30.68 48.2331 9.00339 -1.41906 -2158 4 33.5189 32.8245 30.8394 -9.09046 9.48004 8.12592 -2159 4 34.8804 33.6211 31.3233 -29.3839 -17.782 -5.29467 -2160 6 35.2611 23.7526 9.83248 5.28039 9.63542 14.9856 -2161 4 34.4624 23.9143 9.32096 3.45609 1.41047 -6.97204 -2162 4 35.624 22.9154 9.5528 3.26088 -11.8232 -8.34585 -2163 6 42.4243 15.7233 8.97763 12.8326 1.39623 12.6931 -2164 4 41.658 15.328 8.60072 -22.8346 -8.994 -22.1277 -2165 4 42.104 15.9534 9.85586 1.77226 3.68974 5.84069 -2166 6 7.76866 28.8533 32.9548 -11.0049 17.2013 -15.4709 -2167 4 8.04862 28.1203 33.4848 1.42969 -15.0059 16.0601 -2168 4 8.50079 29.0495 32.3677 8.58058 4.20069 -3.59376 -2169 6 17.6953 41.2515 36.4663 -11.3067 -18.3758 74.5383 -2170 4 16.8889 41.7296 36.6796 -1.19906 6.43806 -6.60961 -2171 4 17.8689 41.3412 35.574 12.2332 11.1792 -57.8962 -2172 6 28.5157 24.2416 15.5518 -29.4686 -13.3801 -11.1317 -2173 4 29.0166 24.9984 15.2559 10.2779 3.66755 -9.57255 -2174 4 28.1226 23.7858 14.7645 18.214 7.11075 11.8426 -2175 6 20.955 16.2999 1.15679 52.4547 14.172 -5.31351 -2176 4 20.9215 15.3848 1.33551 1.21723 -32.5558 11.4722 -2177 4 20.0795 16.5686 1.08505 -57.8144 13.7968 -3.85053 -2178 6 31.1684 40.7359 5.3086 9.60886 -48.7905 -14.3252 -2179 4 30.3201 40.4364 4.96776 -1.1434 5.1051 1.34806 -2180 4 31.1111 41.6485 5.46945 -11.8258 44.905 11.395 -2181 6 29.926 24.7744 36.4585 -3.76808 18.8348 4.26027 -2182 4 30.4252 25.4661 35.9713 -7.21832 -13.6313 5.02454 -2183 4 29.9738 23.9763 35.9568 8.68635 -20.1437 -13.5665 -2184 6 8.66863 31.0429 3.90108 5.49181 -25.3701 -11.391 -2185 4 7.74616 30.7992 3.95988 -7.56137 -0.630176 -1.16432 -2186 4 8.75287 31.8877 4.30735 2.25384 31.6916 10.4967 -2187 6 5.52708 32.7014 11.4113 -17.1068 -29.6258 4.38787 -2188 4 4.72561 33.1583 11.715 12.8879 6.23598 -5.09299 -2189 4 5.16474 31.7796 11.3163 19.6841 23.1791 1.24929 -2190 6 45.6525 35.4522 20.4433 4.50188 -15.2767 -13.8779 -2191 4 45.1533 35.403 19.6071 0.884587 3.9764 11.125 -2192 4 46.1815 34.6145 20.4501 -8.61117 18.3435 2.22997 -2193 6 19.5135 2.78077 9.78076 -23.679 -24.2198 -16.6656 -2194 4 19.3296 3.70289 9.60293 -7.62346 7.89228 3.64078 -2195 4 18.7563 2.26696 9.35595 24.4568 20.2801 14.4664 -2196 6 54.9521 9.08257 10.915 1.41457 -13.8994 3.08946 -2197 4 54.8451 8.89609 11.8656 1.69601 3.75098 -5.72792 -2198 4 0.659909 9.73404 10.7859 1.63405 2.05096 5.26063 -2199 6 21.028 26.5613 14.7909 22.3934 -16.1712 -61.6784 -2200 4 21.2545 26.1082 13.8887 -5.63248 33.4215 43.8962 -2201 4 20.0757 26.5096 14.8457 -4.66041 -4.09977 8.40724 -2202 6 14.1565 30.5187 27.5481 43.0568 3.88252 13.2649 -2203 4 14.5478 30.2647 28.4319 -11.7888 3.54471 -30.6513 -2204 4 14.9443 30.8429 27.0102 -33.9181 -6.53128 14.6047 -2205 6 29.8147 17.3367 31.0866 -27.8518 -4.92818 12.2149 -2206 4 30.6554 17.4646 30.6741 20.9401 8.7355 -10.9161 -2207 4 29.248 18.1063 30.9142 12.1966 -0.59561 3.44929 -2208 6 50.8794 17.2985 27.8251 -38.7154 2.44379 -6.74856 -2209 4 49.927 17.6315 27.8951 41.9068 -8.6615 -2.42711 -2210 4 51.4551 17.8493 28.3603 -3.47276 2.02156 5.1771 -2211 6 46.2645 37.0852 13.9854 4.42941 -15.3994 -45.1385 -2212 4 46.1048 37.4162 14.8449 -7.65894 23.339 32.9902 -2213 4 45.682 37.569 13.3645 -0.578519 -6.08013 10.2779 -2214 6 38.1859 37.2676 33.1408 3.52211 -11.0724 24.5555 -2215 4 38.5393 37.4103 34.0404 -6.68303 -10.0954 -6.88307 -2216 4 38.6219 37.9461 32.6369 2.42637 17.4604 -15.0111 -2217 6 41.8357 13.3473 31.1178 -16.0625 23.8584 17.742 -2218 4 41.5851 13.9423 31.8754 7.82637 -22.3228 -20.2899 -2219 4 42.4009 12.6411 31.4368 6.59024 -10.1979 3.85371 -2220 6 46.9027 12.6459 17.8387 -27.1897 30.7666 -32.0186 -2221 4 46.619 13.5972 17.8049 11.7948 -22.8605 3.48595 -2222 4 46.5208 12.2901 16.9886 18.0608 -3.03081 22.7278 -2223 6 32.0582 10.0955 10.6527 -31.4378 50.3229 23.4622 -2224 4 31.7762 9.76632 11.5317 8.81554 -8.40176 -19.9459 -2225 4 31.6698 11.0464 10.7004 29.7372 -48.0302 -12.3835 -2226 6 34.0062 11.3773 6.75186 17.7871 30.589 25.6979 -2227 4 33.4869 10.5999 6.69262 -19.6684 -30.9606 -3.70709 -2228 4 33.8274 11.7035 7.66069 0.227829 -0.558148 -16.2574 -2229 6 45.3288 30.8634 19.4834 2.25993 -0.395596 -7.26595 -2230 4 45.2654 30.706 20.4282 2.85912 -9.1252 8.63447 -2231 4 45.808 30.1003 19.1195 -1.86475 4.39364 7.74954 -2232 6 20.3535 0.575918 7.15275 2.53913 19.7072 2.1264 -2233 4 20.3036 0.62077 8.11765 -6.02971 -5.31178 -3.74759 -2234 4 20.3373 41.5708 6.90351 -3.42232 -20.4047 0.354773 -2235 6 15.9901 39.4523 4.14302 -22.6863 14.3541 -4.96379 -2236 4 15.4898 39.956 3.48033 13.9059 -6.08345 -3.0001 -2237 4 15.6535 39.8695 4.95456 5.06581 -11.7067 3.21286 -2238 6 52.4222 16.4823 25.1021 7.38571 -14.026 0.748627 -2239 4 51.9391 16.8928 25.8315 -3.23714 5.96419 -6.435 -2240 4 52.4547 17.0876 24.3371 -9.72126 -3.91711 12.1205 -2241 6 38.5305 12.9945 3.24722 36.6577 77.8042 9.91619 -2242 4 38.7269 13.7231 3.96388 -16.2716 -45.5952 -32.5571 -2243 4 38.0745 12.2732 3.61889 -23.0516 -27.5087 18.4748 -2244 6 35.1404 29.6968 31.1683 -32.7778 -10.63 75.6098 -2245 4 35.326 30.1595 30.3922 19.5999 28.8984 -42.5223 -2246 4 34.769 30.3505 31.8393 8.36493 -22.8372 -28.4638 -2247 6 9.52941 33.7628 4.86075 -28.4918 10.8311 18.4951 -2248 4 9.24769 34.3211 5.62607 6.24621 -9.23174 -22.6788 -2249 4 10.3628 33.3905 5.10095 17.2263 -8.07265 -0.549435 -2250 6 21.5384 22.0668 20.5377 -8.24916 -13.7408 18.0665 -2251 4 20.8389 22.6833 20.2982 1.69112 5.82217 1.92954 -2252 4 21.3229 21.7148 21.445 5.44386 11.4228 -26.5573 -2253 6 37.5752 11.1922 41.2961 -25.7405 -15.8592 15.4541 -2254 4 38.0284 11.8044 40.7564 10.4246 30.4728 -30.151 -2255 4 38.2644 10.586 41.5433 15.0535 -11.8566 15.4014 -2256 6 33.8981 1.42806 38.7459 -9.94409 -6.93964 -8.18458 -2257 4 33.592 0.608166 38.3248 2.39341 2.703 9.2739 -2258 4 33.9534 1.28552 39.7002 -3.4763 3.29487 -4.45631 -2259 6 4.57081 26.6822 28.0049 6.08842 -57.033 -35.5124 -2260 4 5.0914 25.8197 28.0746 -15.9746 40.4578 4.78317 -2261 4 4.85783 27.3427 28.6052 16.6445 16.915 24.1865 -2262 6 10.2586 0.903759 11.6235 -14.777 -30.5961 35.2813 -2263 4 10.598 1.12099 12.5147 -1.53351 -1.03605 -18.7158 -2264 4 10.5217 1.55247 11.0069 12.731 34.1315 -22.4253 -2265 6 17.6428 19.8087 2.34625 28.3489 11.7442 10.4095 -2266 4 17.8694 20.4455 1.65312 -0.920106 -2.92675 2.15413 -2267 4 18.5186 19.4679 2.66241 -18.7748 -2.39069 -7.57655 -2268 6 32.4269 25.6656 16.4745 -22.7384 46.4686 12.005 -2269 4 32.9526 26.0936 17.1754 -0.693509 -13.2017 -11.5041 -2270 4 32.8268 24.9018 16.1119 18.5502 -33.1172 -3.66835 -2271 6 33.2526 10.6326 0.323883 9.44704 -29.8166 -9.67306 -2272 4 32.8511 9.97264 41.5994 12.5609 21.6724 15.7642 -2273 4 34.1113 10.2426 0.662313 -26.6835 12.0422 -7.05376 -2274 6 4.94395 4.51414 10.1428 13.8645 5.4827 29.102 -2275 4 4.09398 4.95549 10.181 -4.94694 -3.34603 -2.54834 -2276 4 5.29018 4.56097 11.0773 -8.61071 -3.77852 -28.7481 -2277 6 27.0981 16.9726 9.55361 -31.982 10.5528 -14.2027 -2278 4 27.1645 17.5497 10.32 4.78099 0.707575 6.97209 -2279 4 26.2221 17.2303 9.15822 25.9284 -7.90001 11.4222 -2280 6 9.97547 10.5192 19.3751 2.18725 8.20489 55.882 -2281 4 10.4385 9.92127 18.8097 14.3325 -20.7925 -15.5795 -2282 4 10.1136 10.195 20.3283 -2.00877 10.2565 -41.5362 -2283 6 19.5726 8.5313 27.8509 32.1681 -5.32712 19.6321 -2284 4 20.0623 8.73326 28.6965 -13.9453 -3.32017 -28.6613 -2285 4 20.1531 7.88958 27.3718 -16.7413 15.1406 10.2365 -2286 6 47.0715 38.9553 23.1297 -19.9487 1.16408 5.20576 -2287 4 47.6755 38.9992 22.3956 6.55525 -5.77104 -8.99339 -2288 4 46.1921 38.7934 22.7438 5.29072 4.97192 1.21114 -2289 6 19.6864 25.3648 11.2698 -35.9279 -4.62509 3.50742 -2290 4 18.9891 24.6498 11.3772 26.0807 25.4649 -7.71219 -2291 4 19.2193 26.1995 11.535 7.74761 -20.7647 -6.77192 -2292 6 27.3916 13.4622 15.7395 34.9583 -25.2468 -27.4167 -2293 4 26.6227 13.8144 16.1317 -23.8298 14.7279 29.1585 -2294 4 28.0863 13.1847 16.3728 -7.05347 8.15442 -0.924368 -2295 6 18.6718 14.1326 1.43279 -0.407031 -28.5308 -28.57 -2296 4 18.3771 15.0354 1.29678 -0.169849 11.7565 -8.38297 -2297 4 19.1904 13.8513 0.615983 -22.2167 19.1803 27.2908 -2298 6 42.3082 22.0346 32.4819 -45.1257 5.10199 -13.868 -2299 4 42.1064 21.5657 33.301 1.02444 -1.81924 7.74271 -2300 4 41.4227 22.4584 32.2639 35.231 -14.359 4.36271 -2301 6 10.0299 9.44853 2.50633 35.8335 -20.1603 -5.5533 -2302 4 9.22808 9.80314 2.87263 -22.9312 8.40439 12.9687 -2303 4 10.3707 8.71125 3.07205 -18.436 14.324 -8.13067 -2304 6 6.82989 1.45163 22.0085 -48.1074 -31.7833 -34.6048 -2305 4 5.93364 1.52189 21.5813 27.761 13.2569 19.2226 -2306 4 6.99793 0.508973 21.801 12.0554 14.7409 9.93393 -2307 6 11.2802 27.0298 18.9733 1.62982 48.8223 -5.8971 -2308 4 11.8533 27.1031 19.7597 -5.53045 -6.49976 -4.21856 -2309 4 11.2066 27.9871 18.6476 2.337 -33.8373 14.078 -2310 6 41.4807 20.5084 27.2133 -10.1157 30.3313 5.28758 -2311 4 41.6238 21.1535 27.9303 0.1153 -0.646751 -15.7402 -2312 4 41.3475 19.7242 27.7174 2.20222 -28.2193 4.24429 -2313 6 15.4457 24.115 33.4309 -8.0908 -15.9975 4.96928 -2314 4 14.6694 24.1264 34.0087 5.2648 16.329 -3.20307 -2315 4 15.6051 23.1634 33.3621 10.6851 2.75783 3.25666 -2316 6 36.1374 16.3773 10.0083 -2.95201 1.72364 21.0093 -2317 4 36.0354 15.4723 9.6971 0.275369 -1.57281 -6.84486 -2318 4 36.1532 16.3058 10.9756 2.3103 1.89663 -9.38056 -2319 6 51.7249 16.2592 2.09899 -0.8354 -35.479 4.00209 -2320 4 51.3025 16.6477 2.84061 -15.4293 29.383 24.1936 -2321 4 51.7588 15.3279 2.40044 5.70816 13.7616 -13.313 -2322 6 23.409 8.55726 39.7719 39.5062 -11.15 -25.6965 -2323 4 23.7264 8.82822 38.8637 -18.295 -2.70527 32.3134 -2324 4 24.154 8.00621 40.1033 -17.8621 14.2471 -2.43096 -2325 6 36.7611 34.4487 21.1056 -9.59584 -7.71653 -9.58874 -2326 4 37.1943 34.5847 20.2534 -2.45984 1.11901 0.357954 -2327 4 35.8017 34.351 20.9183 13.0848 5.20904 4.89404 -2328 6 14.146 8.88688 27.2949 11.3522 43.6232 -16.453 -2329 4 13.5534 8.17113 27.3093 -27.716 -37.4722 8.68734 -2330 4 15.0033 8.5993 27.5988 11.0136 -4.6565 4.44913 -2331 6 20.6652 37.4903 25.1946 -10.211 -17.9881 -36.0994 -2332 4 20.7454 36.6557 24.6643 4.11278 14.2078 23.4923 -2333 4 20.5382 38.1243 24.4693 3.50396 4.35638 18.4557 -2334 6 28.825 24.4792 30.0383 -7.87557 -12.5525 -14.3175 -2335 4 28.2203 24.3409 29.2957 -5.62902 14.2643 8.72595 -2336 4 29.6177 24.0933 29.6588 14.1928 -3.34691 9.72359 -2337 6 8.38024 12.0023 23.6849 17.6034 -17.8042 43.8798 -2338 4 9.33151 12.0391 24.0095 -25.5352 0.9508 -22.7134 -2339 4 7.93543 11.4413 24.3789 8.15752 13.9726 -18.9857 -2340 6 16.0957 26.6613 22.9482 -4.23776 -4.88874 3.00129 -2341 4 16.4041 25.8866 22.4682 2.11349 3.20317 -0.347462 -2342 4 15.2797 26.4088 23.4009 6.04671 4.79823 1.078 -2343 6 22.346 41.3881 9.48723 24.9275 -16.664 -2.62618 -2344 4 22.5706 0.299269 9.06271 5.87112 18.1013 -4.15908 -2345 4 21.5005 41.5154 9.87839 -30.5435 3.49176 4.55444 -2346 6 49.3776 19.1851 32.3736 41.1751 -38.6142 12.6649 -2347 4 49.9515 18.5305 32.8666 -19.8114 22.1793 -24.5398 -2348 4 48.9751 19.6643 33.0815 -18.7203 16.5505 12.5326 -2349 6 29.672 28.434 31.2292 -0.0990093 -59.7528 33.1636 -2350 4 30.5672 28.114 31.0525 8.33151 24.242 -15.2883 -2351 4 29.4026 27.6233 31.7702 -3.76231 36.9508 -17.5145 -2352 6 5.09757 39.1181 23.5694 28.9365 -16.8561 66.257 -2353 4 5.426 38.785 24.4883 -20.96 9.44698 -53.4069 -2354 4 5.17377 40.064 23.6953 -4.19226 13.7611 -6.16678 -2355 6 42.9396 13.594 41.6013 33.1291 -45.1938 12.1175 -2356 4 42.8466 14.3322 41.0449 -16.6361 37.6348 -21.2948 -2357 4 42.1546 13.3797 0.17078 -22.3633 5.8076 7.08965 -2358 6 21.2201 12.4318 7.37385 41.5974 -14.6934 -10.3279 -2359 4 20.2896 12.3563 7.35505 -36.2241 5.92132 -7.85999 -2360 4 21.5284 11.6004 6.96932 1.7608 11.2928 4.8084 -2361 6 43.1404 26.8989 37.6922 38.0431 -66.5876 34.8581 -2362 4 42.455 26.3454 37.3085 -15.3628 11.0452 -11.3741 -2363 4 43.7284 26.1839 38.1775 -25.099 52.0029 -25.4853 -2364 6 19.5406 10.6485 41.687 -7.00401 -34.9019 -10.1363 -2365 4 19.0738 10.6767 0.596923 -7.19888 -1.38148 21.2635 -2366 4 19.8536 11.5162 41.559 12.2515 43.5875 -9.13673 -2367 6 53.6223 10.061 3.2559 12.5469 7.56169 -12.6981 -2368 4 54.2024 10.8465 3.22155 -5.5124 -7.95383 7.8004 -2369 4 54.0687 9.40413 2.68363 -10.8512 12.6529 5.34221 -2370 6 17.5742 20.1926 28.4231 -27.2496 23.4973 23.4861 -2371 4 18.0413 19.6307 27.8376 17.787 -14.8025 -21.0857 -2372 4 18.1273 20.2938 29.2048 3.54631 -0.489564 0.0042962 -2373 6 36.884 7.32584 1.68504 -56.6071 21.2656 -14.3658 -2374 4 37.7051 7.59774 2.01592 38.2946 9.18211 20.2394 -2375 4 36.4748 8.1931 1.44071 3.42518 -20.8507 2.42249 -2376 6 29.2181 41.4159 1.83346 -7.01124 13.363 14.2223 -2377 4 28.4272 0.01466 2.15652 15.3791 -9.50345 -13.4545 -2378 4 29.1899 41.2946 0.880744 -4.61983 7.49126 -6.31737 -2379 6 13.5157 3.09172 8.12958 -12.3356 7.91728 -16.4605 -2380 4 12.824 3.78046 8.01164 12.4629 -9.10221 7.3254 -2381 4 13.8551 3.1491 9.02604 -1.1531 -1.24526 3.73064 -2382 6 15.0243 29.578 18.5071 -0.689822 5.1468 -1.91807 -2383 4 14.6889 28.924 17.8685 -1.8514 4.35612 11.642 -2384 4 14.2858 30.1508 18.7969 8.46412 -5.78667 -10.3485 -2385 6 10.5031 24.7013 24.3729 39.9308 52.3958 -21.489 -2386 4 10.8696 24.6855 23.439 -22.6214 -1.85919 30.3756 -2387 4 10.1444 23.8694 24.566 -23.1097 -44.7323 0.689524 -2388 6 2.33043 13.8499 25.1512 12.2217 -8.49201 10.1592 -2389 4 1.51988 13.5482 24.7402 -5.80441 -9.83551 -11.7005 -2390 4 2.2572 14.7938 25.1495 -10.3249 16.8303 -2.61333 -2391 6 31.8608 32.7615 29.8175 -5.917 1.92483 -13.0568 -2392 4 30.9148 32.9142 29.9093 1.86919 3.45723 4.06263 -2393 4 31.9038 31.8703 29.4643 1.33296 -6.10517 -4.90202 -2394 6 37.5413 40.8309 33.9785 -53.8639 -49.1526 -10.38 -2395 4 37.2515 40.0243 34.5353 23.0474 40.5808 -8.35317 -2396 4 36.818 40.8104 33.2846 24.4839 11.2763 19.2644 -2397 6 24.0486 38.1463 34.3459 4.38709 -25.8386 -29.9356 -2398 4 24.1932 38.0251 35.2675 1.20986 12.6476 31.9448 -2399 4 24.4562 37.3431 33.9843 -4.45208 9.66559 -5.62065 -2400 6 37.1813 22.5726 7.37313 12.7367 -26.0408 21.8779 -2401 4 37.6868 21.7363 7.50199 -14.9443 17.386 1.08188 -2402 4 37.2974 22.7741 6.46124 2.1827 3.60906 -24.8808 -2403 6 4.31908 23.2435 35.594 -25.7168 -2.52913 6.61784 -2404 4 4.31865 22.3787 35.1609 -1.33991 4.89576 -0.266123 -2405 4 3.37757 23.4898 35.7698 13.7393 -2.9658 -3.46645 -2406 6 15.7444 14.893 2.66063 14.3192 36.2435 46.5189 -2407 4 15.9445 15.8567 2.71494 4.00237 -25.0016 7.78932 -2408 4 15.3014 14.8369 1.84861 -12.1852 -13.1154 -36.1328 -2409 6 48.1607 23.1823 2.03014 17.998 -4.54201 -11.9107 -2410 4 48.5744 23.458 2.84259 8.43731 2.94545 12.5813 -2411 4 48.9225 22.9045 1.46682 -22.9697 5.41467 1.46601 -2412 6 24.1212 19.9771 21.5555 -13.5297 -6.85262 15.9953 -2413 4 24.2241 19.3198 22.2577 -12.7792 13.8262 1.69378 -2414 4 24.7627 19.6352 20.9706 23.452 2.79195 -33.2435 -2415 6 10.5793 29.3754 5.15175 -1.75103 26.9922 -14.4666 -2416 4 9.93004 29.8841 4.64694 -13.9608 -12.0643 5.47156 -2417 4 11.3599 29.8389 4.86113 16.4531 -5.21099 6.28998 -2418 6 5.96767 27.6933 31.2336 10.2296 -18.0279 -26.5205 -2419 4 6.63185 27.1353 30.7398 -17.0624 11.0978 13.8341 -2420 4 6.49058 28.2721 31.7915 6.44996 0.578865 12.7715 -2421 6 18.5397 25.8071 15.3312 30.8629 -17.2743 -78.9847 -2422 4 18.3277 25.7099 16.2038 -28.7942 6.39581 79.7195 -2423 4 17.897 26.3418 14.8644 -17.4943 11.9017 11.8989 -2424 6 52.0949 37.2335 11.1138 -0.736115 -25.1617 0.200807 -2425 4 52.5552 36.4743 10.7101 2.49656 11.0988 9.7325 -2426 4 52.7586 37.8745 11.3958 -2.29245 7.10647 -7.85035 -2427 6 46.8562 14.6296 7.3094 -39.0502 -6.9365 63.794 -2428 4 46.1382 15.0906 7.8718 34.2719 -4.68193 -40.7336 -2429 4 47.0431 13.9061 7.9424 14.2062 7.46383 -20.3992 -2430 6 22.2508 0.698906 41.6783 16.129 -5.34947 -25.8041 -2431 4 22.2008 1.66415 41.7125 4.72421 -6.65403 -6.59212 -2432 4 22.9559 0.389699 41.0229 -20.0941 20.4891 31.5318 -2433 6 4.05761 14.7345 9.27152 -10.7438 13.6286 -6.0443 -2434 4 3.56043 15.5915 9.15395 12.8436 -23.8424 -1.56379 -2435 4 4.93811 14.8828 8.92118 3.87558 5.66633 -1.10852 -2436 6 37.2917 12.6666 37.0157 -30.741 -16.0859 47.3668 -2437 4 37.7371 12.676 37.8973 0.89189 9.6387 -16.8975 -2438 4 36.3707 12.3712 37.2872 32.4569 8.65188 -22.8431 -2439 6 26.6682 29.0903 40.5985 -18.9168 16.4285 3.4146 -2440 4 27.032 28.2632 40.812 19.8197 -36.7417 16.2821 -2441 4 26.6469 29.0593 39.6552 2.37875 14.8387 -20.8034 -2442 6 7.22455 13.851 3.31845 32.6668 -55.3021 -17.7697 -2443 4 8.0198 14.2759 3.60088 8.05656 35.1068 9.02454 -2444 4 7.66854 12.9807 3.04146 -45.3946 28.1811 11.8363 -2445 6 8.95271 34.8627 28.8342 33.802 -52.1542 -15.9648 -2446 4 9.89817 35.0055 28.6074 -18.5208 0.484683 7.95646 -2447 4 8.56267 35.6958 28.9173 -17.8026 46.8286 13.0667 -2448 6 37.1756 40.0691 40.1061 46.0034 7.56439 6.60252 -2449 4 36.245 40.1688 40.0074 -20.2243 -4.13511 -1.70673 -2450 4 37.2907 39.5142 40.8911 -6.64471 -1.97244 -3.69085 -2451 6 30.3689 6.165 27.2364 16.9392 12.8422 63.3115 -2452 4 30.1126 5.75506 28.1249 0.00544273 9.78172 -37.0876 -2453 4 31.0397 6.83064 27.5702 -18.6179 -11.6186 -23.6342 -2454 6 10.4791 22.885 18.2972 2.22892 -25.7937 -34.5052 -2455 4 11.3494 23.0331 18.653 10.7715 4.73748 7.10061 -2456 4 10.6446 22.3032 17.5049 -10.188 21.0769 23.5682 -2457 6 35.8886 14.2524 40.1239 38.6938 29.9036 -1.43051 -2458 4 35.4161 14.6576 39.3846 -1.71718 -13.5804 13.4977 -2459 4 35.4021 13.6019 40.5864 -31.0402 -18.1501 6.5583 -2460 6 6.71723 1.08854 17.7001 -3.83901 -60.8198 25.71 -2461 4 6.23156 1.19942 18.5167 -3.21909 18.7445 0.671973 -2462 4 6.88149 0.099135 17.7878 0.895752 34.2898 -15.7018 -2463 6 41.3468 34.0461 33.1794 10.5682 19.0983 -18.7578 -2464 4 40.4721 34.2712 32.8864 -29.2649 -1.70533 3.43004 -2465 4 41.8357 34.5632 32.5195 11.425 -3.18121 9.05585 -2466 6 37.2595 0.990816 41.287 9.45411 17.3584 -9.40071 -2467 4 37.687 0.20533 40.9743 -1.4253 -22.058 -8.3634 -2468 4 37.4586 1.01742 0.30817 4.28067 1.92511 18.4856 -2469 6 25.2602 30.9527 6.20609 -41.9214 10.7977 -12.9978 -2470 4 25.877 31.4326 5.6764 28.9604 0.775163 -4.96937 -2471 4 24.4759 30.9469 5.60333 12.4846 -9.23957 25.2824 -2472 6 14.2056 24.502 28.3086 -25.5247 14.5131 -24.5719 -2473 4 14.1882 23.6623 28.7056 13.4522 -31.4953 30.087 -2474 4 13.7133 24.2842 27.5041 7.94148 19.2098 -3.82225 -2475 6 34.2051 26.2238 36.0112 -48.9031 41.3361 24.9979 -2476 4 35.1144 26.3624 36.1822 32.7561 -2.50775 4.45543 -2477 4 33.7446 26.9807 36.5344 19.2218 -36.9328 -23.3608 -2478 6 32.3568 8.33098 28 25.7802 40.2385 3.20277 -2479 4 32.7565 9.24505 28.063 -37.9579 -17.4528 3.85033 -2480 4 33.1461 7.94224 27.6538 8.5967 -27.8742 -9.28785 -2481 6 11.7867 0.286536 26.9724 -1.3913 -35.2382 4.72224 -2482 4 11.7865 41.2385 26.6946 0.846362 23.7064 4.93964 -2483 4 11.6054 0.272418 27.9282 2.03777 4.09428 -12.4872 -2484 6 1.68124 0.254113 10.3309 8.7986 -13.2184 -15.0921 -2485 4 1.59717 41.2916 10.7333 -0.0350141 -2.89412 -0.990995 -2486 4 1.41389 0.849687 11.0071 -7.7361 15.4014 20.6266 -2487 6 6.75173 13.8377 8.23874 -3.6693 30.6435 -30.4665 -2488 4 6.43924 13.9799 7.29904 9.51956 -14.6006 30.1073 -2489 4 7.1653 14.6974 8.43116 5.95594 -9.45057 4.81521 -2490 6 22.2348 20.5564 6.16471 -24.0844 -9.72934 13.195 -2491 4 21.6727 21.3518 6.25881 9.87637 -7.56006 0.262552 -2492 4 21.7029 19.8181 6.55593 11.5262 14.9976 -6.6436 -2493 6 17.385 20.4497 10.8769 -35.9329 27.9153 -37.8305 -2494 4 16.5515 20.156 10.4074 25.3596 -4.97581 21.0147 -2495 4 17.441 21.3848 10.5386 11.6957 -25.2138 21.3318 -2496 6 17.7006 4.52737 19.573 -11.3777 -34.9061 -6.08889 -2497 4 17.032 4.43128 20.2569 -5.49224 11.1956 3.68583 -2498 4 17.4813 3.72403 19.0236 15.4315 33.5846 4.92098 -2499 6 0.483339 18.1114 40.0861 11.4726 -7.5634 -25.4826 -2500 4 0.218803 18.6551 40.8031 -6.40406 19.3 17.6992 -2501 4 1.29471 18.4968 39.6981 -7.50073 -9.94226 4.45973 -2502 6 22.9439 24.8131 27.8304 -1.07592 37.7895 -56.3844 -2503 4 22.8309 25.5845 27.1671 -0.125595 -37.7338 24.1587 -2504 4 22.7938 25.2149 28.6606 -3.1997 14.6603 34.334 -2505 6 42.7926 39.1547 26.7662 4.75434 20.2168 6.00074 -2506 4 43.0175 38.5002 26.1242 -2.01943 -24.6309 -11.9253 -2507 4 43.3024 39.9142 26.4608 -1.73796 0.515913 11.2644 -2508 6 26.2338 3.05974 21.8008 -0.713756 21.3652 -6.58596 -2509 4 25.6341 3.75271 22.1513 17.432 -13.3686 -8.49125 -2510 4 26.841 3.50549 21.1637 -15.4189 -7.95734 10.2455 -2511 6 54.5913 9.88629 29.5891 14.6194 -0.200122 15.6168 -2512 4 54.0185 9.11016 29.6389 -2.18077 1.53735 0.0476299 -2513 4 54.8498 10.0557 30.5251 -12.748 -2.88746 -21.9109 -2514 6 24.7662 33.7505 20.5324 -4.4887 -11.5901 7.32024 -2515 4 24.6764 34.6709 20.8407 -1.82029 -5.26135 -2.53883 -2516 4 23.9322 33.4503 20.1388 -0.463927 12.2923 -3.35723 -2517 6 41.7034 16.3049 0.90063 -4.83399 22.4927 -47.1255 -2518 4 41.2734 15.9533 1.64089 -16.394 -13.425 40.883 -2519 4 42.6233 16.3659 1.12415 18.2298 -9.67465 4.77205 -2520 6 23.3998 27.9207 27.4832 -10.7606 37.0497 -28.3533 -2521 4 22.8282 28.3407 28.1441 5.00816 -9.79407 0.156118 -2522 4 23.2556 28.495 26.6632 8.58882 -24.5485 28.392 -2523 6 32.7859 37.2984 18.7364 25.7014 -40.2058 6.96479 -2524 4 33.7401 36.9719 18.7703 -32.5146 22.7172 4.70252 -2525 4 32.7784 38.1932 18.4283 6.4981 19.1078 -10.0488 -2526 6 21.2249 27.6889 4.78917 1.7584 -25.2435 -20.8654 -2527 4 20.596 27.4146 5.46499 -5.42949 1.48454 -4.75098 -2528 4 21.0369 27.1287 3.96943 -0.427807 22.4392 26.4825 -2529 6 54.9457 17.9605 1.83049 24.1732 12.1415 15.992 -2530 4 54.6765 17.1472 1.44643 -11.2843 -21.2768 -12.0273 -2531 4 54.1938 18.5428 1.86671 -18.1074 1.0363 -7.50679 -2532 6 36.7435 10.702 6.59289 -49.1612 2.30359 2.88264 -2533 4 35.7736 10.9925 6.66913 36.3355 -9.83622 -8.29906 -2534 4 36.7226 9.77144 6.87602 6.19961 4.27664 0.325158 -2535 6 54.2959 4.49421 14.021 -47.0247 26.1641 -8.2037 -2536 4 53.712 4.99768 13.3924 28.2438 -8.88077 8.93165 -2537 4 53.834 4.66365 14.8572 10.6634 -9.95324 4.36694 -2538 6 22.1071 12.8195 32.0067 31.7906 8.9597 -11.0311 -2539 4 21.2967 13.3066 31.9589 -27.922 0.108445 -0.906739 -2540 4 22.6887 13.2954 31.3728 -6.4895 -15.5456 16.1837 -2541 6 15.3021 36.6565 4.03444 -21.8215 23.8176 13.2077 -2542 4 15.3262 37.6185 3.88215 -1.10116 -7.72226 9.53853 -2543 4 16.0423 36.3695 3.52653 17.7184 -15.2462 -10.6327 -2544 6 23.951 1.27123 5.71091 12.3119 19.4094 13.4558 -2545 4 23.1735 0.716989 5.76524 -11.3354 -5.61231 -0.786433 -2546 4 24.0519 1.77027 6.55293 -6.00641 -12.6326 -15.7345 -2547 6 14.2792 12.648 15.8066 19.0644 9.13243 11.8341 -2548 4 14.5911 12.5731 14.893 -12.6174 -10.6299 -3.28453 -2549 4 13.3818 12.3002 15.9605 12.2346 2.97194 -15.7557 -2550 6 15.0388 40.2481 6.5891 -30.9219 -16.0267 -20.9978 -2551 4 15.8926 40.3583 6.97574 17.8619 16.6743 19.574 -2552 4 14.4622 41.0349 6.73493 18.0926 -11.8876 3.06612 -2553 6 48.5605 32.6308 12.0872 21.4935 -15.1737 -19.6402 -2554 4 48.2882 31.8163 11.6222 -11.7375 10.5522 8.8403 -2555 4 49.3772 32.8772 11.5869 -20.063 0.749688 13.0696 -2556 6 11.2909 31.5377 7.21713 -14.6129 -9.26005 -15.8818 -2557 4 10.6224 30.9548 6.78826 17.7824 9.96971 10.6082 -2558 4 11.6163 32.1134 6.50388 0.884245 -9.77636 6.63484 -2559 6 30.1231 27.9968 10.2226 9.10006 8.28679 -14.6513 -2560 4 30.718 28.7273 9.95045 -8.34799 -9.59518 10.9295 -2561 4 29.9727 27.4897 9.40845 -5.6962 -0.318113 1.27302 -2562 6 27.6759 22.1164 17.3809 2.93811 -8.1883 -22.8269 -2563 4 27.2909 21.5233 16.7142 1.55949 -2.9899 10.1125 -2564 4 28.0309 22.8242 16.8263 2.77593 4.45495 11.6125 -2565 6 12.9654 4.59514 18.1625 -0.934721 -11.3223 -0.518608 -2566 4 13.4589 3.798 18.4727 -12.2499 12.1104 -13.3514 -2567 4 12.4628 4.36939 17.3497 12.7979 1.84773 4.27522 -2568 6 19.7203 6.71654 19.0744 25.855 21.5282 16.2244 -2569 4 18.977 6.16103 19.2554 -18.9537 -21.446 -0.739234 -2570 4 20.1996 6.78409 19.9214 -9.72031 -0.922856 -11.6068 -2571 6 37.1527 31.3787 11.4669 20.5156 -3.08539 55.9419 -2572 4 36.5467 31.6235 12.1801 -19.4555 -0.126446 -17.2692 -2573 4 37.8531 31.0173 12.0578 -6.7166 -8.42047 -30.0342 -2574 6 3.11862 16.2015 27.3491 -14.8948 -19.7352 -9.46107 -2575 4 2.52427 15.4561 27.6487 20.3886 21.5408 -12.2486 -2576 4 3.15348 16.212 26.3649 -6.24389 -0.0501167 23.7097 -2577 6 15.7133 9.97724 38.3591 30.328 17.4212 13.8857 -2578 4 16.1258 10.8398 38.0549 -11.3336 -30.4403 16.2583 -2579 4 16.257 9.66317 39.1359 -16.0932 10.0631 -23.9552 -2580 6 13.4043 14.2884 8.2363 15.0986 25.1191 -5.83206 -2581 4 13.804 15.2225 8.33958 -5.13839 -47.7054 6.28407 -2582 4 14.0947 13.5837 8.31616 -11.6402 16.8216 1.41307 -2583 6 1.71524 24.3141 36.392 36.4901 -22.2748 31.9402 -2584 4 1.86474 25.1068 36.8985 9.35176 9.25273 5.49175 -2585 4 1.1215 24.6177 35.7571 -36.8309 10.6894 -41.0698 -2586 6 11.1862 26.5319 32.9688 15.239 -24.9993 36.2438 -2587 4 10.9649 26.8002 32.096 -11.5382 16.0703 -24.8314 -2588 4 11.1647 27.266 33.6054 -7.17864 1.89937 -11.754 -2589 6 29.5773 0.765668 36.2911 32.6527 8.9619 33.1448 -2590 4 29.1495 0.596705 35.4758 -23.483 -6.97315 -25.4485 -2591 4 28.9625 1.07408 36.9696 -5.35236 0.153158 -12.2969 -2592 6 43.6099 13.1071 23.908 -7.75428 16.7256 -33.2383 -2593 4 42.8302 13.3868 24.3919 -4.08537 -1.1131 9.93358 -2594 4 43.3622 13.2586 22.9511 7.4693 -9.27191 32.0602 -2595 6 7.44309 19.7767 19.6705 17.8438 12.6527 -6.23579 -2596 4 6.73015 19.1919 19.919 -3.61392 -10.9972 -0.189724 -2597 4 7.6227 19.7194 18.722 -11.1837 -0.704544 3.42764 -2598 6 24.4259 4.29913 7.83629 -8.5248 -0.10499 -3.36953 -2599 4 24.144 5.21077 7.98541 -0.150025 -7.47068 -3.31634 -2600 4 24.9904 4.0546 8.57206 4.90899 -0.271036 -1.18338 -2601 6 51.4883 30.2308 31.1674 -14.7545 1.56633 -0.747328 -2602 4 50.5925 29.8847 31.2768 -1.35209 3.55691 8.49804 -2603 4 51.5844 30.2463 30.2146 11.2248 2.3182 -11.9335 -2604 6 0.913373 23.6795 16.8764 44.9279 -35.4578 23.1065 -2605 4 0.053834 23.3329 16.7065 -24.7033 4.18361 -15.1926 -2606 4 1.39802 22.8443 17.1197 -4.68332 28.5423 -3.90241 -2607 6 45.0884 19.3939 15.6913 9.05154 29.148 -44.7311 -2608 4 45.9115 18.9543 15.4906 10.1171 -6.0821 0.331933 -2609 4 44.8041 18.9926 16.4702 -27.3917 -26.115 43.7395 -2610 6 17.5003 8.70625 40.5861 -20.5343 49.5779 -9.15489 -2611 4 18.1762 9.35755 40.8219 0.532033 0.318295 -4.52849 -2612 4 17.8864 7.89597 40.8225 20.4785 -39.0634 11.6529 -2613 6 30.1832 27.259 27.1983 -17.9859 30.5387 -1.70378 -2614 4 31.0843 27.5469 27.0174 5.19664 -5.65516 3.8328 -2615 4 29.6652 28.1124 27.2385 17.8651 -30.9588 0.0373123 -2616 6 43.0672 26.1987 28.3737 -1.21405 11.7795 -35.2128 -2617 4 43.2187 25.7399 27.5308 2.18298 5.51683 1.33219 -2618 4 43.1307 25.5038 29.0079 -1.74848 -11.3154 21.2466 -2619 6 27.987 7.5851 3.0601 9.13665 18.2748 23.7588 -2620 4 28.1896 6.93215 2.40721 -2.30749 -24.2619 -13.6918 -2621 4 28.5512 7.39371 3.84357 -9.52219 0.418204 -9.11945 -2622 6 44.6779 7.22362 10.1855 -3.82519 12.3682 29.7072 -2623 4 44.5846 7.37997 11.1613 -8.64186 4.71212 -23.3906 -2624 4 45.2067 6.43644 10.1815 9.68596 -14.557 -3.94398 -2625 6 23.537 20.3907 32.2607 -4.33975 0.880185 -5.57314 -2626 4 23.324 21.1985 32.7413 -3.519 5.94106 -1.71472 -2627 4 23.9311 19.8373 32.9365 5.99895 -7.24541 1.02787 -2628 6 37.5412 21.0533 29.2807 6.26587 16.0676 16.0196 -2629 4 37.3761 20.3248 28.6837 -16.0493 -11.7352 -10.5522 -2630 4 36.7218 21.4261 29.6708 7.43039 -8.09007 -9.52559 -2631 6 49.2859 29.0787 28.7031 8.16517 -18.5587 -1.11584 -2632 4 48.658 29.8007 28.598 1.09858 8.52384 -10.5349 -2633 4 50.1522 29.3365 28.3345 -7.12297 8.09394 6.40204 -2634 6 47.5144 18.1684 15.2382 -13.098 45.3115 -50.4885 -2635 4 48.063 17.6794 15.7982 26.613 -22.2712 34.0874 -2636 4 48.011 18.9832 14.9644 -13.0138 -21.3801 10.9042 -2637 6 23.2587 11.168 16.5961 -34.2623 -16.0228 11.9175 -2638 4 23.8181 11.8474 16.2701 22.3391 18.1069 -12.9732 -2639 4 23.6107 10.3074 16.3447 5.63526 2.71733 -4.05723 -2640 6 3.14661 8.32736 23.1966 -5.33081 14.6732 5.33529 -2641 4 3.33443 7.84562 22.3891 5.23826 -4.81966 -4.36628 -2642 4 3.62138 9.17513 23.1245 -2.82501 -4.35917 1.75332 -2643 6 0.508878 16.1819 6.17622 16.4304 7.97407 55.7173 -2644 4 1.47866 16.3831 6.12713 -25.5039 -9.61354 -6.44341 -2645 4 0.329178 16.1408 7.1857 2.48639 -0.0834422 -46.7437 -2646 6 43.1796 15.6993 5.84098 -15.9449 -20.1226 -10.4934 -2647 4 42.9586 16.4507 6.36104 0.864404 19.5468 17.3894 -2648 4 44.0486 15.8407 5.47017 17.9332 8.6581 -2.45416 -2649 6 16.7038 35.4743 34.4518 -23.198 12.4372 32.502 -2650 4 15.9504 35.0582 34.0028 7.47206 -3.63127 2.95791 -2651 4 16.3197 35.7905 35.3305 20.1374 -9.24319 -26.2799 -2652 6 38.8854 7.73874 15.6833 27.6202 35.8952 13.402 -2653 4 39.2486 7.07212 15.1014 0.737034 -8.76325 -8.48971 -2654 4 39.6641 8.33099 15.9666 -32.1226 -27.7665 -11.1551 -2655 6 42.0076 36.5182 13.641 -8.45099 16.164 -4.64077 -2656 4 41.9228 35.5752 13.5656 2.538 -16.9665 4.44933 -2657 4 41.1544 36.8356 13.3036 3.7559 4.14555 2.82714 -2658 6 54.2986 15.3848 32.1119 10.5246 -16.1102 10.831 -2659 4 0.035655 15.9755 32.3754 -8.42237 -3.15332 1.00609 -2660 4 53.5781 15.9253 31.7943 -3.3302 7.96061 -4.64421 -2661 6 22.8954 13.9973 39.0304 35.7671 -1.21675 7.49641 -2662 4 23.2761 14.8055 39.421 -4.93619 -7.73369 -6.00904 -2663 4 21.9819 14.1606 38.8837 -32.0989 6.28079 -4.51925 -2664 6 48.0426 28.53 4.78367 -18.7604 -12.0579 33.007 -2665 4 48.5209 28.7824 4.01456 21.1512 11.8238 -22.7946 -2666 4 47.6247 29.3288 5.14776 5.26678 3.3179 -1.38234 -2667 6 48.833 10.6059 2.66638 -9.19187 -9.9608 -41.9733 -2668 4 48.2371 10.184 3.25557 -19.2293 -15.3999 15.8868 -2669 4 49.4018 11.1117 3.19515 27.1663 25.8201 26.2609 -2670 6 17.1043 29.3494 4.41938 0.116954 -3.05469 4.91749 -2671 4 16.3442 28.823 4.73493 -1.75912 12.177 1.49975 -2672 4 17.4207 29.929 5.14153 -0.429925 -17.6765 -0.899977 -2673 6 27.7901 7.33424 26.577 58.6208 -10.7281 -9.65958 -2674 4 28.6921 6.89516 26.6033 -20.1634 35.8081 4.28732 -2675 4 27.2961 6.54785 26.6418 -36.3357 -24.7905 3.70209 -2676 6 18.0242 22.0537 22.5144 -27.9591 -16.1551 -40.0832 -2677 4 18.4878 21.2118 22.5153 10.7066 -2.42354 6.7168 -2678 4 17.4966 21.98 21.6478 21.0889 16.8172 36.9195 -2679 6 22.144 25.0979 16.6837 -22.767 31.6961 -6.75713 -2680 4 21.8754 25.6012 15.8609 3.46788 -12.1894 37.0641 -2681 4 22.4796 24.2953 16.3382 13.1119 -24.3628 -7.92486 -2682 6 25.5147 28.4379 7.13209 -32.2353 18.5879 42.0502 -2683 4 25.3191 28.6153 8.09624 16.8162 -18.2828 -29.7283 -2684 4 25.4949 29.3399 6.82105 5.5127 9.28731 -21.7507 -2685 6 42.5447 24.7469 23.7482 -26.0567 17.8354 -0.260974 -2686 4 41.659 25.0561 24.0862 27.8337 1.55541 -7.56443 -2687 4 42.5141 23.8045 23.8516 -5.7883 -22.6777 0.706816 -2688 6 6.24511 16.6188 2.47068 -21.6781 9.7655 5.77715 -2689 4 5.36273 16.9874 2.41541 -6.24724 13.8235 -1.18511 -2690 4 6.01398 15.7093 2.58331 16.9883 -26.009 1.35247 -2691 6 47.3719 33.28 1.46148 -3.99946 1.01934 -28.2481 -2692 4 46.9803 34.1218 1.66358 -4.59906 12.9067 -8.65937 -2693 4 47.69 33.0389 2.30921 14.6803 -12.3184 23.7614 -2694 6 1.27616 36.1851 24.8829 8.16993 1.58395 -5.27854 -2695 4 0.639753 36.4584 25.5359 -13.8461 11.829 3.50901 -2696 4 1.57271 35.3754 25.2942 10.46 -9.74103 -2.86729 -2697 6 20.9413 29.0442 16.4303 -37.0385 3.95749 11.2157 -2698 4 21.4069 28.5201 15.8013 19.747 -14.8546 -14.4583 -2699 4 21.4101 29.8248 16.6953 16.4704 9.62387 -0.234111 -2700 6 18.6701 32.5426 14.1399 -11.935 -28.2137 10.094 -2701 4 17.8036 32.9051 14.2078 -15.3524 29.2867 2.90472 -2702 4 18.4356 31.618 14.3552 23.1856 4.50503 -1.59621 -2703 6 15.7338 41.7002 0.007017 -29.1796 -38.8659 -6.04008 -2704 4 15.5134 41.1073 41.1476 16.5192 17.684 16.0218 -2705 4 15.1804 41.3134 0.738607 16.9589 18.7767 -12.0866 -2706 6 20.5358 18.4015 7.20723 -36.4209 10.7746 11.3165 -2707 4 20.1727 18.4996 8.12034 18.5895 1.11111 -8.73102 -2708 4 19.7156 18.4439 6.66948 20.5956 -6.66311 2.45516 -2709 6 35.3359 2.82506 1.61733 -4.03181 47.7257 29.2165 -2710 4 34.9541 3.20961 2.47337 19.1106 -23.159 -34.5889 -2711 4 35.8528 3.61912 1.28524 -9.69035 -30.1723 1.40188 -2712 6 49.0059 19.6751 24.9502 -26.306 10.305 -4.58994 -2713 4 49.8292 19.282 24.7191 18.9727 -16.8119 -2.00329 -2714 4 49.219 20.61 24.9195 -6.54834 1.96917 8.98321 -2715 6 26.0427 7.1974 41.5664 19.1127 -25.9459 -27.3591 -2716 4 26.6886 6.46136 41.6822 -6.92827 19.3426 1.38611 -2717 4 25.5576 7.23966 0.456505 -11.7101 6.8047 33.8929 -2718 6 22.0248 3.60461 29.0185 -16.0846 7.25678 -9.40108 -2719 4 21.194 3.80897 28.5456 14.569 -4.87522 0.502932 -2720 4 22.1959 4.40114 29.525 4.81678 0.210141 7.58007 -2721 6 27.8548 32.5394 20.644 30.2008 -27.0251 30.2495 -2722 4 26.9598 32.7332 20.4747 -36.3343 12.7784 -11.814 -2723 4 28.412 33.1097 20.1287 0.615935 11.6015 -11.5439 -2724 6 8.3956 24.7909 3.45677 41.8783 30.6212 2.1827 -2725 4 8.85983 24.2427 2.83372 10.4085 -11.4169 -11.9204 -2726 4 7.65564 24.3184 3.74512 -41.6031 -24.257 6.19876 -2727 6 30.5856 41.7288 15.6573 18.8319 11.6475 40.5199 -2728 4 29.9513 0.161741 16.3149 8.82373 -8.1621 -4.69308 -2729 4 30.0935 41.6309 14.8822 -24.2072 -8.84927 -42.274 -2730 6 48.0984 5.63232 21.2085 -24.8678 -8.67647 -10.7387 -2731 4 47.6235 6.28714 20.6867 8.63769 7.09972 -0.446275 -2732 4 47.3595 5.05066 21.4474 12.3779 0.983941 9.20385 -2733 6 39.4236 23.163 35.7324 -26.6807 -22.8308 -31.4054 -2734 4 39.8477 23.6904 36.3502 31.9199 30.6139 46.0523 -2735 4 38.8623 22.5516 36.2186 -1.29306 -3.58423 7.04543 -2736 6 51.5883 33.3617 5.78995 -19.5798 -55.0773 -18.3228 -2737 4 51.7861 34.2574 5.89467 9.96767 53.6603 7.25336 -2738 4 51.5145 33.1869 4.82901 1.99858 6.27826 11.2132 -2739 6 40.1205 17.6413 30.7797 3.51386 -32.8888 9.0941 -2740 4 39.6335 18.3955 31.0853 6.47279 10.0891 -2.42254 -2741 4 40.8254 17.9321 30.1952 -5.08805 1.72673 -6.80625 -2742 6 46.4235 9.81086 18.5807 -13.6096 13.2326 25.0066 -2743 4 47.164 10.4099 18.4597 3.17276 -2.49269 -0.272695 -2744 4 46.3941 9.2422 17.832 2.02048 -17.819 -25.0993 -2745 6 15.8844 41.0843 31.9336 24.9021 -3.26155 -16.7898 -2746 4 16.5805 40.7078 31.3592 -9.31569 -10.1627 6.74042 -2747 4 16.1791 0.090931 31.8861 -11.051 9.97246 9.22539 -2748 6 48.5496 25.7276 14.9325 -23.4699 4.48431 -20.1118 -2749 4 49.4421 25.9075 14.7294 36.7388 1.67727 3.80263 -2750 4 48.1707 25.827 14.039 -11.0362 0.596064 15.3478 -2751 6 39.2225 28.9892 36.1575 1.81804 -9.3363 -11.5399 -2752 4 40.0459 29.1043 36.6225 6.32097 13.8964 11.0865 -2753 4 39.5169 28.7877 35.2623 -5.25992 -5.15898 -10.721 -2754 6 37.325 21.0738 14.9394 -7.85324 -20.9229 -64.7065 -2755 4 37.9996 20.7799 14.2865 -1.58038 10.9233 26.036 -2756 4 36.5898 21.2349 14.28 11.1979 5.88457 46.2171 -2757 6 32.4971 22.8607 15.7433 -7.91212 -33.4559 24.7905 -2758 4 31.7632 22.4534 15.25 1.55934 10.0805 -2.32687 -2759 4 32.5592 22.2921 16.5663 4.31702 21.463 -27.4441 -2760 6 18.5773 8.13014 37.5708 2.8796 34.5567 21.0854 -2761 4 19.1021 8.93687 37.8089 1.20854 -19.8484 -10.1251 -2762 4 17.9431 8.09722 38.288 -3.97249 -3.14491 3.87795 -2763 6 46.9308 30.3817 11.0144 7.20248 -9.32119 -46.6603 -2764 4 46.4987 30.7035 10.1833 6.25688 -3.94108 30.979 -2765 4 47.431 29.6318 10.6212 -6.26387 6.19468 23.2459 -2766 6 54.6355 13.051 30.6677 -0.631529 -12.3617 0.377161 -2767 4 54.9401 12.1973 31.0202 -4.70537 6.73717 3.83911 -2768 4 54.6706 13.679 31.4001 -0.542159 7.57402 -2.77471 -2769 6 32.2973 35.1412 27.9506 0.702746 7.41177 51.9011 -2770 4 32.3519 35.6753 28.7977 -4.11304 1.55554 -34.3644 -2771 4 32.0809 34.2722 28.2835 1.42742 -15.3938 2.35714 -2772 6 4.45353 25.396 31.7914 -28.2716 -32.1048 1.32297 -2773 4 5.00928 24.905 32.4172 3.79617 9.45861 3.32159 -2774 4 4.83781 26.2295 31.6234 26.2458 34.1175 0.407684 -2775 6 40.7781 38.1509 21.8521 -13.1408 -33.509 11.5706 -2776 4 40.6716 39.044 22.1698 7.33695 21.0707 -1.24628 -2777 4 41.4481 38.0623 21.1738 10.5508 14.8215 -9.14642 -2778 6 26.6931 9.85845 27.4042 -43.8759 24.145 24.882 -2779 4 26.9952 9.1619 26.8761 23.7363 -35.7414 -23.7206 -2780 4 25.7673 9.60487 27.6152 14.5566 8.07269 5.62533 -2781 6 53.3967 39.4485 11.7649 68.843 -10.0355 -14.0333 -2782 4 54.4148 39.3855 11.5456 -53.2103 8.20916 12.7106 -2783 4 53.105 40.2482 11.2866 -1.29569 -7.05369 14.3337 -2784 6 35.3292 21.4155 2.23587 15.106 -7.83484 -18.4876 -2785 4 34.912 20.5764 2.48744 -1.27765 6.93695 -0.309601 -2786 4 35.8084 21.2289 1.37944 -21.1629 3.53466 26.6292 -2787 6 4.14409 17.1449 33.9131 -16.1644 -22.9901 22.0601 -2788 4 4.14131 16.4411 34.6063 8.69636 10.7601 -14.4963 -2789 4 3.20404 17.192 33.6728 6.06844 1.20479 -9.99864 -2790 6 24.1486 16.1886 14.6752 2.90394 -28.6462 -21.9437 -2791 4 24.2343 17.059 15.0346 0.494679 15.8947 1.83084 -2792 4 23.7735 16.3203 13.7888 -2.47926 -0.947779 4.85435 -2793 6 43.1303 2.83022 26.0988 7.42094 18.4339 -15.1049 -2794 4 42.3152 3.21229 26.4285 -6.54764 -1.84254 4.96768 -2795 4 43.2129 3.23454 25.2082 4.91034 -11.1878 11.8147 -2796 6 40.68 12.1827 1.56051 12.2683 5.96873 16.2718 -2797 4 41.5968 12.2158 1.84207 12.0551 -6.37233 -9.83141 -2798 4 40.2741 12.5174 2.36876 -21.9125 -2.35909 -10.0625 -2799 6 47.3781 8.09655 26.7608 82.0606 26.064 -7.54845 -2800 4 46.666 7.67998 26.3919 -67.6244 -33.3987 -26.4118 -2801 4 48.0445 8.01522 26.0221 -12.6559 5.80771 33.8866 -2802 6 35.8947 30.7223 38.5098 17.2216 52.6179 -38.6143 -2803 4 35.6523 29.9703 39.0072 10.7188 -28.2359 27.6772 -2804 4 36.8587 31.0199 38.5623 -37.3038 -25.1724 3.03639 -2805 6 51.3054 23.2176 32.4969 -40.2617 11.1267 -4.72183 -2806 4 51.571 23.9803 31.9692 8.10126 9.10595 3.65824 -2807 4 52.0738 22.7076 32.6523 27.5758 -14.8312 4.00399 -2808 6 30.6066 4.44965 39.6625 0.615077 -4.04577 -5.4494 -2809 4 30.9728 3.64581 40.0124 3.38991 -22.1323 -0.234101 -2810 4 30.7691 5.02119 40.3987 0.467535 29.3806 6.08815 -2811 6 35.2584 29.6988 2.86074 -18.8762 -20.4699 -30.2285 -2812 4 35.7444 29.7805 2.00551 -3.31399 -2.84145 17.507 -2813 4 34.478 29.0852 2.62897 29.9452 30.586 13.9144 -2814 6 50.3064 26.1399 9.38994 -11.2342 14.6262 -3.47403 -2815 4 49.9288 26.8854 8.86032 11.0364 -25.2497 6.23881 -2816 4 49.6695 25.4035 9.37359 7.94529 9.32604 -3.86417 -2817 6 50.1026 36.8163 26.4125 -14.5138 -5.51826 -11.285 -2818 4 49.5888 36.0167 26.6617 3.79204 13.187 5.56915 -2819 4 50.2319 37.3727 27.1922 -3.20057 1.11223 6.19844 -2820 6 40.3045 23.9511 38.5442 56.3682 27.7758 -3.16545 -2821 4 40.8125 24.7624 38.7991 -6.5383 -29.3065 -12.768 -2822 4 39.4568 24.2221 38.8139 -44.6373 -1.162 12.0349 -2823 6 24.9504 10.7612 30.6561 23.3702 -4.90777 36.4738 -2824 4 25.6234 10.7245 31.4083 -25.7901 9.07318 -40.0098 -2825 4 24.9126 11.6687 30.2959 1.4184 -10.5997 2.42613 -2826 6 5.89627 1.02238 5.41014 -10.9637 -3.10309 -8.95081 -2827 4 5.14436 0.409378 5.47088 11.7326 -0.810065 6.31118 -2828 4 6.70289 0.529043 5.60145 -0.696658 -1.4992 -0.407558 -2829 6 44.282 29.3718 26.2736 69.4655 -24.0165 25.5627 -2830 4 43.5561 29.7046 25.8233 -49.9183 11.7173 -34.3685 -2831 4 44.8903 28.8623 25.6892 -19.9675 5.54095 9.74148 -2832 6 25.3119 10.1784 6.67292 -15.7736 -23.3412 -3.06725 -2833 4 25.6521 11.0537 6.64576 10.6351 24.7362 -4.37451 -2834 4 25.4625 9.79379 5.79618 6.21987 0.326131 1.26241 -2835 6 13.3514 28.0662 2.56722 45.2358 13.6418 17.9819 -2836 4 12.4545 27.8107 2.56105 -32.9681 -11.4511 -11.8173 -2837 4 13.8041 27.7134 1.79344 -6.10921 -0.687749 -0.120894 -2838 6 6.44709 40.2351 18.0254 21.2427 9.30891 -1.39987 -2839 4 6.966 39.4726 17.7533 0.137807 -7.29984 6.20872 -2840 4 5.59682 40.0602 17.6456 -22.1821 0.316247 -4.7234 -2841 6 47.7944 13.5061 2.01255 -17.6425 -30.8617 30.605 -2842 4 48.2016 12.6358 2.19438 -7.04124 7.54818 -3.24284 -2843 4 48.4122 13.9735 1.50015 28.8905 20.8749 -24.4455 -2844 6 13.5944 20.2974 2.4458 20.0315 11.2691 18.6487 -2845 4 13.7883 19.6075 3.10831 1.39134 9.87367 -8.40212 -2846 4 13.0064 19.8713 1.85297 -21.5499 -10.3053 -19.2062 -2847 6 15.2336 0.850818 36.6661 8.37652 40.6516 -23.9146 -2848 4 15.3117 1.46746 37.4264 -6.40063 -24.0213 -7.24367 -2849 4 15.3514 1.51981 35.909 -6.71396 -40.605 26.1829 -2850 6 33.5971 35.2491 15.0847 71.6425 -10.6997 11.4711 -2851 4 33.8969 35.3297 16.0058 -20.0956 -0.49545 -2.4869 -2852 4 34.508 35.0431 14.6807 -47.978 4.31732 -2.67502 -2853 6 21.7981 9.23698 0.429299 24.0185 -25.5324 29.6504 -2854 4 22.426 9.07175 41.6424 8.6426 -4.20457 -11.04 -2855 4 21.1884 9.81045 0.032847 -35.1273 25.1593 -17.3244 -2856 6 38.1453 27.4709 3.0333 47.9463 -55.6761 10.6859 -2857 4 37.7532 27.3037 2.19157 -17.0599 1.14667 -24.2168 -2858 4 37.8405 28.2288 3.44687 -27.291 50.0057 16.1216 -2859 6 38.8714 27.215 11.7709 41.141 -36.7506 -15.3879 -2860 4 38.9285 26.3434 12.2193 -14.3396 10.7389 0.963039 -2861 4 39.5886 27.0941 11.0922 -22.6073 11.6268 16.0227 -2862 6 29.8734 41.5737 28.6987 15.2279 35.2113 -10.5566 -2863 4 28.9552 41.3162 28.7047 -13.1778 -5.77603 2.88395 -2864 4 29.9141 0.263017 27.9132 -0.896253 -12.9147 16.3719 -2865 6 34.03 8.70777 38.0687 38.5763 27.6628 16.1728 -2866 4 34.8607 8.18924 38.1985 -14.88 11.0383 -8.6682 -2867 4 33.3419 8.15213 37.7593 -24.3719 -27.4308 -8.08559 -2868 6 38.8091 27.3495 30.6738 6.32435 -21.1782 -4.52762 -2869 4 38.5154 26.4386 30.4378 -1.34454 21.7952 1.35616 -2870 4 38.3686 27.5808 31.4849 -11.9448 1.82739 7.69603 -2871 6 41.6473 17.269 36.3639 7.45605 15.5752 1.52238 -2872 4 41.3137 17.162 35.483 -10.4634 0.342165 -15.0979 -2873 4 41.7169 16.3923 36.7151 5.72978 -18.5967 8.16978 -2874 6 30.7243 26.977 35.2074 -15.5404 -28.2563 -3.1326 -2875 4 31.3953 27.4345 34.7177 18.5093 15.4635 -5.31058 -2876 4 30.2206 27.5565 35.766 -0.690558 20.2492 9.56945 -2877 6 47.5414 4.09198 27.2867 -2.42911 13.6608 18.2544 -2878 4 46.636 4.37242 27.4325 -10.4037 -2.52064 9.15115 -2879 4 47.5606 3.99786 26.3497 6.55325 -3.96267 -23.0579 -2880 6 20.946 8.39203 7.27322 -27.8597 -45.7319 -0.818331 -2881 4 20.9365 8.74812 8.15774 -0.207227 20.4039 13.5637 -2882 4 21.4094 8.93893 6.67191 21.7448 31.5979 -18.7028 -2883 6 36.8544 13.691 0.855516 -6.96494 -6.58957 -4.7536 -2884 4 37.3845 13.474 1.605 15.5913 2.53244 29.7992 -2885 4 37.0002 12.9032 0.328977 -4.78774 -2.28905 -12.5933 -2886 6 28.5904 20.2994 26.4544 16.2695 -3.42806 -15.5352 -2887 4 28.4835 19.402 26.1318 -1.12761 -3.3858 2.90642 -2888 4 27.7814 20.5406 26.8733 -22.93 6.76513 15.2817 -2889 6 51.6079 16.8571 33.5121 -4.50033 -4.43314 5.93611 -2890 4 51.6159 16.0837 34.101 -3.91985 -0.958274 -7.09147 -2891 4 50.9053 16.6875 32.8669 7.1497 -2.58651 -2.16023 -2892 6 16.2715 32.0073 37.6936 -41.8913 -21.032 -18.7972 -2893 4 16.4093 31.405 38.4555 0.0363557 12.0183 -19.687 -2894 4 15.4977 31.6058 37.1477 38.3353 16.8511 22.6146 -2895 6 14.3407 25.877 13.2155 1.26588 11.3619 -17.2713 -2896 4 13.5013 26.0279 13.6901 5.40221 7.27027 -0.947788 -2897 4 14.4551 26.5608 12.5093 -9.57117 -0.277473 20.5459 -2898 6 54.9749 28.8768 3.30374 1.15612 -53.5629 -1.59986 -2899 4 54.8083 28.9028 2.3467 2.04661 0.129141 5.0455 -2900 4 0.26744 27.9124 3.48546 -12.4506 41.1861 -2.95604 -2901 6 17.22 5.15598 2.57931 -12.7888 -35.846 -9.7104 -2902 4 17.8674 4.52191 2.91459 -1.87097 -9.90488 -4.08214 -2903 4 17.421 5.9071 3.09191 1.36943 25.6696 10.0797 -2904 6 50.6995 33.0507 10.3154 6.59719 15.9916 42.5002 -2905 4 50.6222 33.8517 9.79386 -1.28667 2.08485 -11.8542 -2906 4 50.7575 32.2667 9.79209 -3.80283 -15.7636 -22.9095 -2907 6 28.8826 19.8405 32.3742 18.5732 17.2051 -15.397 -2908 4 29.8373 20.0763 32.2 -31.4986 -11.6613 7.66973 -2909 4 28.4094 20.6578 32.1253 1.55933 -8.77069 7.582 -2910 6 22.4307 12.8248 23.2991 -20.6917 10.5217 33.6658 -2911 4 22.5556 12.3422 24.1574 -2.40655 13.6672 -16.3005 -2912 4 21.7108 13.488 23.4947 18.3613 -16.8762 -11.246 -2913 6 54.7763 15.5394 8.86893 2.10476 3.1215 13.1486 -2914 4 0.465115 15.309 9.51431 10.762 -2.70861 -3.02895 -2915 4 53.9989 15.1653 9.30174 -3.31272 -0.629746 -12.248 -2916 6 10.4518 19.2967 26.1704 43.67 -11.1159 60.7251 -2917 4 11.2502 18.7163 26.2348 -22.5321 13.8961 -6.48776 -2918 4 10.166 19.2541 25.3007 -24.1973 -3.18459 -58.4054 -2919 6 38.6496 20.2998 35.2325 20.2193 -0.813999 -8.63065 -2920 4 39.5955 20.3672 34.9603 -17.6326 -1.16496 9.70871 -2921 4 38.5782 19.6093 35.9099 2.97533 6.68842 -2.65526 -2922 6 17.4906 18.0487 15.2499 -10.3405 45.0299 20.0184 -2923 4 17.3837 17.5615 14.4531 -8.22833 -15.0257 -32.2828 -2924 4 17.2318 18.9864 14.9797 13.5676 -28.3997 10.204 -2925 6 29.6331 0.960567 26.2796 -25.6031 -26.3316 -72.4206 -2926 4 29.3216 1.74647 25.7973 3.40072 6.61544 23.4347 -2927 4 29.2407 0.266373 25.6265 23.6279 16.4272 47.4057 -2928 6 30.4665 12.6849 28.2971 -10.7965 -27.9245 1.17671 -2929 4 29.8272 13.0822 27.7097 -1.40549 16.7134 -9.61387 -2930 4 30.1324 11.7665 28.3519 9.60572 9.94425 5.65357 -2931 6 36.6695 22.1225 33.3577 39.6017 -11.6369 -25.7224 -2932 4 37.5338 21.6663 33.4931 -10.4393 24.3252 -8.31461 -2933 4 36.1732 21.6976 34.0074 -34.1256 -9.27026 38.9845 -2934 6 34.8672 22.4666 14.3113 -12.0535 -16.0605 -66.2467 -2935 4 34.0349 22.4515 14.7407 -19.1997 11.5289 38.0952 -2936 4 34.5417 22.174 13.4128 25.6484 2.69091 24.3313 -2937 6 15.5262 9.60919 7.44527 49.3682 -27.3699 -19.0187 -2938 4 16.547 9.52246 7.26069 -54.7763 6.57045 5.33777 -2939 4 15.1277 8.71762 7.26288 7.76902 16.5773 17.8238 -2940 6 21.8158 28.0339 19.8054 -4.91607 2.79332 -16.2053 -2941 4 21.8614 28.4614 20.6522 -2.04715 7.82991 15.4338 -2942 4 20.8734 27.9328 19.6183 -0.9528 -10.4666 6.26348 -2943 6 34.5348 24.4247 2.43569 30.4222 -68.2311 14.7367 -2944 4 34.4753 23.4054 2.32054 1.69344 45.6403 0.121788 -2945 4 35.3397 24.4934 3.03523 -29.9154 15.8849 -16.545 -2946 6 12.599 20.9348 33.4989 -13.8827 -5.0407 19.8786 -2947 4 11.7591 20.6911 33.9854 14.8004 1.51093 -27.4282 -2948 4 12.4712 20.9089 32.5331 -6.4324 -2.96843 13.903 -2949 6 45.7737 31.1538 8.70434 -2.26925 11.3362 1.64289 -2950 4 45.9542 32.0869 8.96415 -8.39554 -11.7705 -15.6468 -2951 4 44.8313 30.9442 8.82297 5.93432 7.3758 2.64979 -2952 6 15.4817 22.5529 30.1787 5.69125 -30.6905 2.54506 -2953 4 16.2669 22.9885 30.4865 5.73919 23.8488 1.47991 -2954 4 15.7828 21.6299 30.2043 -15.5749 7.04719 -4.74998 -2955 6 39.7421 17.1743 38.4094 21.5551 17.0277 -9.47446 -2956 4 39.5031 16.7163 37.59 -3.21419 -6.16335 13.1695 -2957 4 40.5012 17.7258 38.123 -12.3818 -10.233 9.13463 -2958 6 13.9944 24.6739 0.675362 16.6213 17.4065 1.77653 -2959 4 14.3534 24.6315 1.57006 -7.52322 -5.04497 4.60086 -2960 4 14.2363 25.5684 0.403337 7.11699 -3.23043 -4.31609 -2961 6 31.5223 19.5616 3.57151 -53.5885 6.24325 20.3398 -2962 4 30.9852 19.2876 4.35912 8.49606 10.2921 -25.2864 -2963 4 32.3806 19.3906 3.88708 44.0272 -8.41539 -5.41474 -2964 6 36.1052 25.07 19.4414 -58.1964 5.4792 30.944 -2965 4 37.0178 24.9674 19.4291 53.7837 8.57858 1.17104 -2966 4 35.8724 24.6048 18.6565 -11.4284 -6.26335 -25.0938 -2967 6 51.6856 17.6883 14.8068 3.37141 18.4291 36.2611 -2968 4 51.7159 18.5692 15.274 12.631 -26.1695 -13.2311 -2969 4 51.0805 17.8845 14.1157 -15.036 4.32684 -29.7308 -2970 6 37.7054 27.4905 38.1961 21.1085 51.9404 -4.50496 -2971 4 37.7442 26.8536 37.5026 -5.7586 -24.9449 -15.2301 -2972 4 38.1753 28.2651 37.7886 -14.569 -23.1779 14.5181 -2973 6 34.7911 13.8542 30.7834 63.814 8.34946 -38.9004 -2974 4 35.1479 14.6416 31.2053 -8.52888 3.60926 11.6955 -2975 4 33.9958 13.5796 31.1473 -54.5977 -12.3598 32.1143 -2976 6 19.6332 37.3754 39.9698 -24.3625 -2.8653 -8.02349 -2977 4 20.5737 37.5051 40.1221 10.6449 -2.37562 -1.97502 -2978 4 19.476 36.9037 39.1231 9.83703 4.21653 7.37417 -2979 6 40.9393 34.0697 21.4586 2.1394 -11.0927 -27.2527 -2980 4 41.1855 34.0244 22.3739 -0.995015 -5.02364 12.6588 -2981 4 40.8269 33.1391 21.1809 -5.56645 12.5591 1.05516 -2982 6 32.9542 27.2131 26.5676 21.8236 31.3611 42.3808 -2983 4 33.7455 27.7378 26.9411 -38.3522 -19.3744 -9.62352 -2984 4 33.2804 26.8388 25.7801 14.7034 -8.88898 -37.5519 -2985 6 24.4045 18.6625 15.6046 15.6323 5.3487 0.0952382 -2986 4 23.6496 19.2317 15.7207 -14.8084 -1.4602 1.41466 -2987 4 24.5649 18.2576 16.462 -0.219489 -3.50303 9.55317 -2988 6 29.9663 1.63299 9.06934 -19.1782 58.0281 -13.4952 -2989 4 30.0652 0.728361 9.20589 6.15764 -53.3299 8.23098 -2990 4 29.142 1.69178 8.53744 13.8409 -0.846673 8.85197 -2991 6 31.4884 20.0987 7.87879 28.0207 -11.7442 -56.0977 -2992 4 31.929 19.6692 7.07379 -7.62771 20.3934 38.6055 -2993 4 30.8102 19.4535 8.0257 -16.4635 -8.90407 20.6678 -2994 6 35.0404 3.79156 33.2694 -1.07326 -4.91424 22.8916 -2995 4 34.2545 4.23611 32.9039 10.815 -2.65177 -4.17514 -2996 4 34.969 3.91026 34.2418 -2.62674 -1.77539 -18.1187 -2997 6 43.9504 7.96546 12.9857 17.1829 -21.9111 0.113786 -2998 4 43.3325 7.29581 13.3448 8.44862 12.3123 -3.96012 -2999 4 43.4563 8.73573 12.7333 -15.1408 11.4953 0.0339333 -3000 6 44.1156 32.6759 16.9403 5.31814 23.9263 4.94933 -3001 4 44.7028 33.4557 16.8081 -6.11209 -18.3833 -3.28173 -3002 4 44.1603 32.5425 17.8901 -3.26507 -3.06823 6.73624 -3003 6 40.6044 27.171 19.0399 5.35236 -7.54795 -39.8413 -3004 4 39.9756 26.4797 18.7399 3.73803 11.5815 8.49028 -3005 4 41.0398 27.5246 18.2027 -12.4172 -8.32437 32.3474 -3006 6 46.047 23.2024 29.047 17.2683 37.2743 26.3298 -3007 4 46.6657 23.8797 29.4684 -18.5589 -27.346 -17.4569 -3008 4 46.486 22.3548 28.9238 8.34839 -6.65718 2.80441 -3009 6 42.6215 30.6103 18.862 -5.01232 -15.325 -26.4249 -3010 4 43.5272 30.7476 19.0895 18.324 11.0008 12.4889 -3011 4 42.704 29.9429 18.1625 -17.0641 3.12823 2.85026 -3012 6 36.1251 10.8932 23.2678 23.6581 36.1082 4.04534 -3013 4 35.2523 11.2865 23.1129 -2.80799 -1.69562 1.02392 -3014 4 36.6983 11.6913 23.4963 -28.2294 -33.6871 -7.78786 -3015 6 13.7386 31.5223 15.7271 -4.49361 3.73805 -16.8081 -3016 4 14.6779 31.7192 15.7387 3.94655 -1.56597 5.72926 -3017 4 13.381 32.0318 14.979 -1.5565 -4.12563 8.0657 -3018 6 33.1703 41.4275 27.7797 10.5813 -15.702 68.4674 -3019 4 32.9714 0.101499 27.0951 -7.66273 31.9341 -41.1766 -3020 4 33.2579 0.043937 28.6255 4.60937 -17.5422 -27.6682 -3021 6 32.9019 22.9042 31.4856 -22.5274 37.748 -5.90861 -3022 4 32.2895 23.1741 30.7829 6.44322 -22.1433 -13.1277 -3023 4 32.7242 23.6662 32.0583 13.0029 -8.58894 11.8377 -3024 6 27.6559 16.8629 6.38841 0.759442 -6.33883 29.8789 -3025 4 27.8611 17.2083 5.54221 8.69809 17.4791 -25.8043 -3026 4 26.8031 16.4594 6.24591 -13.957 -6.38022 2.63501 -3027 6 47.2651 11.6173 26.0576 8.33461 35.0159 47.6166 -3028 4 47.0912 11.6838 27.0214 -5.10661 -22.4254 -22.6877 -3029 4 47.7461 12.4597 25.9756 -3.10554 -9.06377 -24.8427 -3030 6 27.5595 7.06242 7.64189 36.0057 -29.1625 5.70238 -3031 4 26.7484 7.49683 7.83093 -25.0876 11.7282 17.2448 -3032 4 28.0841 6.86482 8.45622 -15.7481 15.6684 -17.1357 -3033 6 39.8009 9.06823 11.973 -19.1879 4.0297 -12.8881 -3034 4 39.4826 9.27056 11.0665 6.39012 -4.37616 15.6201 -3035 4 38.9894 9.1094 12.5089 2.28999 7.64442 -1.09803 -3036 6 18.1977 33.4656 36.103 -47.2434 1.22325 7.58723 -3037 4 17.6693 33.9565 35.4324 13.0563 -6.22307 9.58411 -3038 4 17.491 33.069 36.7104 31.5801 5.82297 -20.8408 -3039 6 37.1917 26.5507 0.720984 -4.45309 15.6177 5.32368 -3040 4 37.3846 25.6567 0.44907 -1.85313 -8.64798 -1.56679 -3041 4 36.2207 26.6114 0.739208 8.96605 -1.46339 -9.13916 -3042 6 44.1887 19.6251 36.8885 40.0452 -6.58607 -3.19327 -3043 4 45.0262 19.1233 36.6753 -25.2412 9.90919 11.1214 -3044 4 44.4881 20.5478 36.9825 -7.95545 -4.32402 -1.12283 -3045 6 27.7744 6.35339 35.6933 13.1235 -8.00403 1.40836 -3046 4 27.1655 6.97567 35.3121 -8.4989 9.93248 -6.95364 -3047 4 27.2748 5.53908 35.7675 0.865215 -2.72076 5.22838 -3048 6 34.7673 16.4826 20.8897 25.0208 -26.1622 5.09639 -3049 4 35.5801 15.8751 20.9364 -40.3091 28.8833 0.638889 -3050 4 34.1629 16.1653 21.5964 8.34467 8.45669 -12.6288 -3051 6 39.0349 20.9701 40.4369 -35.0548 -83.2732 -20.3586 -3052 4 38.7355 20.0763 40.8679 21.616 52.9309 -20.1646 -3053 4 39.3277 21.5521 41.0958 10.956 28.6509 41.127 -3054 6 10.8075 27.9275 1.66251 45.0798 11.5101 -39.3642 -3055 4 10.1207 27.6506 2.20454 -46.3214 -11.9312 37.0665 -3056 4 10.864 28.8887 1.77269 -0.956148 -2.75571 -0.87801 -3057 6 47.0235 23.1304 13.2457 -34.1648 -14.46 -9.62139 -3058 4 47.6809 23.5773 12.718 7.19949 7.22116 -4.18429 -3059 4 46.2703 22.9258 12.6132 27.3011 3.73645 28.26 -3060 6 34.5862 28.4037 10.6629 -11.4192 -4.75939 1.42695 -3061 4 34.4799 27.7252 11.3319 -5.35328 -3.69815 4.40234 -3062 4 35.5403 28.4214 10.6073 9.29856 11.2923 -14.2157 -3063 6 3.3474 17.5828 14.2796 -19.4871 24.8451 -12.2706 -3064 4 3.54237 16.6973 14.5399 7.15819 -24.2504 13.4427 -3065 4 3.84281 18.1577 14.8755 9.98901 -5.90389 -1.38432 -3066 6 27.7213 11.5993 7.52196 5.39723 39.0715 -5.17771 -3067 4 27.6701 12.604 7.61024 4.43832 -37.6789 -1.1729 -3068 4 27.2296 11.2227 8.25132 -2.72363 -3.1191 8.53492 -3069 6 41.4314 28.3382 9.01837 19.0589 -0.973961 -18.7609 -3070 4 40.8555 28.7961 9.62238 -6.75468 20.1798 6.66135 -3071 4 41.7073 28.957 8.28743 -10.8025 -14.2077 17.7393 -3072 6 42.0854 4.7797 8.18851 -21.257 14.5957 -52.3899 -3073 4 42.0432 5.70949 7.81908 14.9695 -22.9802 20.9203 -3074 4 41.8649 4.22501 7.38905 12.6142 12.8494 32.4876 -3075 6 28.4682 8.6325 40.3242 -61.7219 6.47809 -5.55454 -3076 4 27.7379 8.57122 40.9835 27.869 -4.13123 -2.00049 -3077 4 27.8882 8.69791 39.5144 34.8971 -1.31486 9.68376 -3078 6 0.711352 18.2475 15.2828 -1.03732 14.0577 26.4962 -3079 4 1.6037 18.2498 14.9622 18.0256 -6.96047 -13.9963 -3080 4 0.201613 17.7329 14.6701 -10.6254 -13.4061 -11.9404 -3081 6 7.11345 16.2289 40.4432 8.45023 -35.9074 47.1296 -3082 4 7.17312 15.3057 40.7986 -0.221024 11.0765 -27.8146 -3083 4 7.22051 16.6703 41.3088 -5.23596 22.4775 -22.5048 -3084 6 41.0858 8.62552 20.9048 11.0684 -11.3616 26.0286 -3085 4 40.3918 8.42716 20.2762 -10.0062 9.73992 -12.3328 -3086 4 41.3944 9.53753 20.8124 -4.81268 6.06535 -10.7329 -3087 6 31.7073 7.42286 37.542 -14.8479 -9.90339 6.69006 -3088 4 31.4959 7.12404 36.6506 2.47263 0.526998 -6.01676 -3089 4 30.9335 7.11441 38.0458 14.4773 7.59586 -0.291785 -3090 6 40.7266 11.6476 25.425 -35.4896 13.4329 -16.1803 -3091 4 40.7395 12.5913 25.6925 9.9362 -18.5419 -7.18222 -3092 4 41.5423 11.2236 25.6435 22.7694 -4.71413 12.394 -3093 6 29.8665 30.1579 6.66307 26.6562 -4.16721 8.5177 -3094 4 30.5555 30.7343 6.31583 -2.18777 1.73834 -10.5199 -3095 4 30.3573 29.3259 6.76714 -13.2281 -1.59651 -6.45815 -3096 6 40.8439 24.5837 5.68012 15.8615 33.1962 -4.14396 -3097 4 41.3457 25.4223 5.9023 -8.27611 -29.5734 -8.52614 -3098 4 40.1119 24.5659 6.27901 -12.3156 -1.80355 11.8721 -3099 6 34.3917 9.09675 20.4219 17.6262 -1.15942 17.9162 -3100 4 33.57 9.43601 20.7884 -5.86563 4.88571 -3.34935 -3101 4 34.2167 8.80099 19.5352 -13.2656 -6.03918 -15.2606 -3102 6 18.2311 33.5548 26.5354 9.60899 -55.578 -54.4315 -3103 4 19.159 33.2107 26.4405 -23.3884 24.4218 8.45675 -3104 4 18.1621 34.044 27.3085 3.33799 34.4716 53.9641 -3105 6 28.9072 17.4193 26.7965 8.90265 -1.34032 10.3526 -3106 4 28.3267 16.8801 26.2506 -9.53448 5.67773 -5.57268 -3107 4 28.3756 17.7646 27.5432 9.63981 -8.23286 -8.72686 -3108 6 50.4255 35.5446 18.192 14.112 9.6817 -2.74072 -3109 4 50.5661 35.3326 17.2487 -8.6314 -7.47676 15.7559 -3110 4 50.5766 34.7477 18.7329 -11.9848 3.75846 -10.2286 -3111 6 2.99463 21.5653 31.4474 1.68271 -21.0005 -22.757 -3112 4 3.33698 22.262 30.8385 -11.1525 -11.1618 12.076 -3113 4 2.83901 20.7479 30.8788 5.9339 29.1288 19.4027 -3114 6 36.1811 18.7457 8.60665 26.0746 50.7707 2.54435 -3115 4 36.1969 17.9289 9.04749 -6.79937 -48.2248 12.3681 -3116 4 35.6147 18.7828 7.85483 -18.853 -7.00319 -22.0811 -3117 6 20.2934 6.48366 33.7248 -33.7925 -21.1439 9.08779 -3118 4 19.8228 6.33509 34.5702 11.9648 11.0481 1.53323 -3119 4 19.9109 5.73333 33.234 17.8653 6.32962 -8.93867 -3120 6 14.0016 30.5326 6.65439 -2.06342 0.226434 14.1624 -3121 4 14.6658 31.0189 7.18657 -8.4774 -5.82658 -13.2159 -3122 4 13.1556 30.6664 7.11082 5.19683 1.19435 -6.65694 -3123 6 36.2738 16.4523 35.7634 28.7444 28.7466 -1.25628 -3124 4 37.2529 16.3082 35.8444 -30.8138 -2.80693 3.80535 -3125 4 36.1869 17.4417 35.6433 -1.25715 -33.4762 0.326736 -3126 6 45.8255 37.6646 9.68707 16.0609 -41.2042 -13.6418 -3127 4 45.4852 38.2919 10.2717 -20.4348 34.8513 25.7777 -3128 4 46.231 37.0083 10.2774 7.06244 2.74597 -12.4723 -3129 6 47.4229 17.9968 27.6368 -1.79372 -57.0164 -4.60636 -3130 4 47.566 17.432 26.8065 -4.8869 24.4286 27.8294 -3131 4 47.3631 17.3546 28.4089 6.87022 22.2846 -25.0829 -3132 6 25.9574 18.2976 0.964228 23.0858 -4.77958 -10.3735 -3133 4 26.3734 18.9022 1.60725 -19.9671 -4.02324 -2.33442 -3134 4 24.9961 18.2982 0.948557 -9.32218 6.60301 10.8105 -3135 6 27.3657 22.4026 4.28337 1.04907 -15.9856 -17.2206 -3136 4 27.2658 23.3197 4.47064 2.83879 26.7243 10.1579 -3137 4 27.3462 22.4079 3.3181 -1.05974 -10.8362 7.50108 -3138 6 3.39902 3.84297 27.6033 -32.797 -16.937 8.3321 -3139 4 3.87422 4.64571 27.4715 26.6916 15.5682 -1.1402 -3140 4 3.96055 3.06079 27.6076 7.92228 2.5358 -5.38712 -3141 6 45.3564 27.6573 28.835 13.8657 -6.64535 19.4164 -3142 4 44.592 27.1099 28.6295 -10.1072 2.65107 -0.516215 -3143 4 45.3903 28.3299 28.161 -2.22034 5.33578 -9.67936 -3144 6 28.3928 32.384 16.2149 35.1766 -7.36337 1.61596 -3145 4 29.2284 32.2059 15.7054 -23.0821 5.0916 11.0276 -3146 4 28.7076 32.6186 17.1078 -8.03404 1.42552 -9.59962 -3147 6 9.90485 33.8293 13.0286 10.5996 -3.42126 36.647 -3148 4 9.63365 33.2371 13.7754 2.50037 15.8816 -14.8106 -3149 4 9.32864 33.6931 12.2897 -16.1444 -6.90665 -19.0975 -3150 6 38.3335 26.6343 14.9205 -0.551684 -24.4487 3.86314 -3151 4 38.658 25.7334 15.149 1.53578 20.736 -5.06851 -3152 4 37.3858 26.5974 15.0972 1.00556 4.30146 -0.183996 -3153 6 31.3571 16.3836 4.2445 -16.7299 -18.7641 16.8138 -3154 4 30.5501 15.9079 4.56795 14.9054 8.61271 -6.80276 -3155 4 31.2311 16.4593 3.29715 -1.72501 9.16645 -9.12782 -3156 6 6.17482 3.39637 6.55833 17.6941 29.4886 56.031 -3157 4 6.41103 3.08651 7.49149 -7.06328 10.7723 -41.2395 -3158 4 5.9143 2.63963 6.07247 -2.51266 -29.5732 -15.1374 -3159 6 42.5954 13 5.61529 2.6815 -10.2341 6.00586 -3160 4 42.2228 13.83 5.89445 -1.70762 9.74234 -1.3058 -3161 4 43.4476 12.9425 6.06763 3.18432 -3.38396 -9.63491 -3162 6 41.0469 31.4032 33.8032 -2.41258 31.7421 -2.74763 -3163 4 40.7074 31.3974 34.7214 7.44932 1.1292 -16.4995 -3164 4 41.1575 32.3688 33.5162 -1.31614 -41.8694 16.6901 -3165 6 52.8576 12.0626 26.2641 9.5895 -24.4248 -55.9842 -3166 4 52.4684 12.727 26.7939 -19.7064 26.0739 18.5009 -3167 4 52.6066 12.2568 25.3043 12.3637 -4.77707 33.6793 -3168 6 39.2086 4.29542 29.0724 8.4008 5.1904 -7.5125 -3169 4 38.4444 4.85752 29.2861 11.0986 -5.7068 1.32154 -3170 4 39.9986 4.64958 29.5231 -9.05665 -5.78587 -2.57989 -3171 6 3.65769 27.0104 11.285 -33.2394 -3.70913 -3.8751 -3172 4 4.59992 26.8829 11.3514 17.6792 2.33561 -5.11125 -3173 4 3.4519 27.7953 10.7423 10.2361 0.60791 3.91121 -3174 6 41.5441 29.6402 25.2654 2.79284 -4.6021 22.0238 -3175 4 41.8464 29.7038 24.3667 4.04268 2.71218 -16.2057 -3176 4 40.7127 30.1073 25.3399 -6.11251 5.69311 -9.79107 -3177 6 50.4754 27.4974 30.671 -6.87832 -12.1873 7.27551 -3178 4 50.0778 27.1279 31.4799 3.22248 2.82006 -4.01445 -3179 4 49.7824 27.9982 30.2275 0.0461655 4.73 -3.38362 -3180 6 32.7876 33.6322 41.7537 -8.7541 -8.89692 -39.0089 -3181 4 33.1671 32.7559 41.8028 5.47994 -11.5785 5.15438 -3182 4 32.9083 34.029 0.675063 4.83491 15.974 33.6037 -3183 6 5.9806 9.64323 7.93715 4.3965 6.41539 -15.2951 -3184 4 5.77829 9.93579 8.8312 0.6559 3.73469 4.68299 -3185 4 6.3228 10.4083 7.4265 1.56495 -8.59939 9.02132 -3186 6 52.7884 25.3949 27.7 -7.43266 -9.74322 -1.44878 -3187 4 52.93 26.351 27.8747 -0.851616 -24.8244 8.41831 -3188 4 52.9998 24.8518 28.4994 7.3809 16.2458 -18.9874 -3189 6 18.6796 23.2043 14.4609 8.49541 46.7244 28.1607 -3190 4 18.697 24.1166 14.872 -21.1178 -26.825 -16.729 -3191 4 19.5981 23.1771 14.2416 15.365 -21.3066 -15.3625 -3192 6 31.2857 9.07887 13.0786 26.2489 -54.2202 -11.3888 -3193 4 31.3193 8.20519 13.5416 -2.63874 16.5358 -10.154 -3194 4 30.7972 9.64602 13.6278 -24.9284 29.9413 31.6235 -3195 6 52.8163 16.833 29.9704 25.4684 -2.46115 -18.7711 -3196 4 53.1785 16.3479 29.2052 -11.8989 0.938692 6.7974 -3197 4 53.5445 17.4528 30.1342 -3.36222 3.81908 9.3955 -3198 6 13.4835 30.6533 11.9137 -46.9609 -12.8402 15.0292 -3199 4 12.8701 31.2475 12.4314 22.3442 -12.341 -15.3642 -3200 4 14.3315 31.0589 11.9363 20.4041 22.2607 2.0467 -3201 6 24.4145 24.6647 11.1793 -22.2983 -41.6602 -10.5575 -3202 4 25.2113 25.1208 11.3859 27.2622 9.38308 11.5927 -3203 4 24.6402 23.6908 11.0915 -11.4513 27.6962 10.6476 -3204 6 11.1203 26.798 5.92715 -0.288466 28.8994 -0.991584 -3205 4 11.4516 26.991 6.8143 4.21529 -7.59652 -0.673238 -3206 4 11.0194 27.7223 5.58288 -7.6649 -30.4822 0.0195949 -3207 6 12.0071 32.3096 4.57291 -4.86243 14.2275 -68.6847 -3208 4 11.7793 31.9281 3.63093 8.01684 14.4954 56.5286 -3209 4 12.2995 33.2463 4.37904 -4.11207 -26.5611 6.70158 -3210 6 6.4322 5.49281 30.4716 35.2368 -18.2726 5.22228 -3211 4 6.85856 6.3256 30.2181 -6.14256 4.86399 -3.96588 -3212 4 5.49729 5.53619 30.4137 -26.8093 16.306 -3.74387 -3213 6 38.1866 39.6 29.3849 -55.2477 -18.0227 -31.7741 -3214 4 37.4363 40.1798 29.0864 28.3626 1.3397 12.8196 -3215 4 37.8398 38.7214 29.0428 28.3274 26.4583 13.0641 -3216 6 52.5811 19.3636 5.41604 51.907 48.1011 -36.5249 -3217 4 52.4834 20.3242 5.17263 -20.1975 -32.0404 8.71389 -3218 4 53.4908 19.2453 4.99747 -31.6145 -20.6418 25.5541 -3219 6 18.3356 9.8205 21.0747 -17.6268 -29.6196 -17.636 -3220 4 17.8021 9.40634 20.3533 -1.88913 9.35392 27.897 -3221 4 19.0546 10.1733 20.5835 25.9839 20.5094 -7.72749 -3222 6 14.4924 41.1161 15.0432 10.1364 3.71296 -9.89663 -3223 4 15.2732 41.1462 15.6022 9.62288 -5.62086 4.10329 -3224 4 13.9031 41.7078 15.5102 -8.32301 1.75038 3.32266 -3225 6 35.9996 23.9069 26.7492 18.6837 -25.8156 -39.8793 -3226 4 35.9246 23.4421 27.5469 -8.45021 -0.659318 44.9575 -3227 4 36.3072 23.1381 26.2025 -8.08285 36.2837 5.17172 -3228 6 35.634 10.4286 26.2543 -16.0886 -36.8378 31.8954 -3229 4 36.0318 10.4196 25.4062 11.0324 6.64788 -31.8122 -3230 4 35.4344 9.46932 26.4326 4.10196 23.0818 -6.20158 -3231 6 45.3004 24.2842 20.2749 24.2383 10.4641 7.4623 -3232 4 45.3515 25.0535 19.6808 2.20237 -7.91345 -3.22769 -3233 4 44.5434 23.7522 20.0895 -20.4117 -5.11737 -13.922 -3234 6 15.8182 39.0515 24.2407 12.965 16.6456 0.954929 -3235 4 15.3741 39.8779 24.5544 7.5658 -17.411 -0.0196462 -3236 4 16.7724 39.3066 24.1247 -29.8541 -4.22386 6.92178 -3237 6 4.60659 25.9073 16.8122 1.83212 2.60998 -1.97709 -3238 4 5.31562 26.4095 17.2499 -5.00617 -6.2898 0.278133 -3239 4 3.79975 26.4302 16.9186 11.5163 2.87992 -0.585475 -3240 6 33.4767 9.9887 32.5701 -44.5277 -5.18869 -27.5725 -3241 4 34.322 10.1593 32.8843 54.6618 16.656 18.5178 -3242 4 33.0203 9.70843 33.3575 -8.70161 -12.0001 8.14623 -3243 6 22.9321 37.514 1.50284 -0.19108 -28.0604 17.8877 -3244 4 23.0149 38.2279 2.13297 1.92014 9.99004 7.14626 -3245 4 22.7552 36.7067 2.06858 1.19451 21.8657 -20.5647 -3246 6 39.1248 20.5474 25.4766 21.2332 -16.8391 26.0428 -3247 4 39.2186 21.3943 25.0643 2.22233 17.645 -5.02625 -3248 4 39.853 20.5019 26.1611 -16.83 0.667515 -19.8449 -3249 6 25.0699 25.071 37.6104 17.3941 16.9986 -26.7924 -3250 4 25.9994 25.4036 37.6322 -19.4928 -16.3283 1.07636 -3251 4 24.8822 24.8366 38.5108 -1.54859 -5.98321 18.8059 -3252 6 12.2108 35.7702 11.4211 -21.274 -0.450661 -24.3109 -3253 4 11.4942 36.1177 10.8268 17.2098 -2.57945 23.3101 -3254 4 12.7534 35.3113 10.7723 8.20233 4.40137 5.7707 -3255 6 42.0318 15.7212 20.1319 23.9789 -4.66934 -19.8056 -3256 4 42.573 15.4482 19.3354 -11.2719 11.6022 18.1956 -3257 4 42.3198 16.6222 20.3614 3.24172 -2.08619 -3.65764 -3258 6 53.203 25.4276 39.527 3.00787 -13.9161 6.63788 -3259 4 53.7641 25.8569 38.8977 9.18601 6.10619 -8.92001 -3260 4 52.4886 26.0297 39.6953 -12.4398 9.9207 3.51955 -3261 6 53.7999 21.7704 1.29423 13.4333 -6.07506 22.1965 -3262 4 54.6908 21.5389 0.969279 -9.57261 -3.1085 -1.99035 -3263 4 53.3016 22.2177 0.619486 -6.56312 6.61298 -22.2093 -3264 6 1.93757 22.4543 20.1748 -8.22485 -1.41006 19.3874 -3265 4 1.60089 23.2534 20.6505 8.04613 -19.7643 -7.74833 -3266 4 2.27012 21.8339 20.8623 2.42307 18.0741 -7.93574 -3267 6 41.1802 16.179 11.484 -8.24259 53.7733 14.6683 -3268 4 40.8475 15.3772 11.8508 -2.32532 -30.9762 7.10209 -3269 4 40.6167 16.8825 11.9353 16.6943 -22.3779 -21.294 -3270 6 17.1967 38.6113 9.60334 5.35995 -1.86267 -8.12923 -3271 4 17.7852 38.6361 10.3521 13.641 -0.452934 12.0217 -3272 4 16.3282 38.6029 9.98982 -18.6262 -0.708432 10.1602 -3273 6 33.1969 12.9538 38.5484 12.352 25.5713 -8.86638 -3274 4 33.6486 13.824 38.4674 -8.05485 -18.2555 -5.8969 -3275 4 33.0335 12.8861 39.4897 4.37007 -7.66636 -4.23751 -3276 6 24.7228 21.6957 39.9776 0.331302 -26.4697 -8.75647 -3277 4 24.5832 21.6143 39.0045 0.235774 0.581704 12.5709 -3278 4 25.2663 20.9218 40.2505 -4.0265 10.6546 -4.86064 -3279 6 13.577 15.5497 27.3411 27.7809 44.9786 27.5516 -3280 4 13.196 16.0821 28.0648 5.30872 -0.0493108 -10.0398 -3281 4 12.9031 14.935 27.2057 -29.8548 -39.4113 -11.0219 -3282 6 24.6863 18.7248 9.26482 -8.80414 -2.51529 14.0236 -3283 4 25.3563 19.2311 8.7609 -6.6335 -0.338001 12.1858 -3284 4 24.3761 19.0911 10.1338 17.243 1.91927 -22.7003 -3285 6 10.9743 8.21046 0.042398 -18.7759 13.8117 62.0104 -3286 4 10.3469 8.74796 0.639501 28.6352 -16.9877 -21.8389 -3287 4 11.7753 8.08291 0.592641 -4.28958 7.52309 -10.9298 -3288 6 15.7499 31.9609 31.3743 -17.6212 -20.5964 15.467 -3289 4 14.8817 31.9157 30.9761 -10.6343 5.00824 -7.09118 -3290 4 16.0827 32.8403 31.1978 10.1106 0.369155 -2.88897 -3291 6 20.3726 39.1695 21.6147 20.5981 -29.5513 41.0934 -3292 4 19.9726 38.3531 21.9994 -5.82675 23.323 -22.8284 -3293 4 21.1172 39.24 22.2595 -11.0324 14.4144 -20.0969 -3294 6 38.8594 19.5251 7.6091 -6.47304 13.0289 -25.1371 -3295 4 38.0017 19.0955 7.57416 -1.20877 -0.517864 1.64758 -3296 4 39.1744 19.3685 8.48411 8.18586 -10.9486 17.219 -3297 6 41.3695 29.7301 21.1465 -57.7285 -14.4296 34.1578 -3298 4 41.7832 29.6286 20.3251 24.9116 3.74799 -36.1007 -3299 4 41.9865 29.9579 21.8177 26.2541 9.18996 12.3917 -3300 6 50.7039 33.8333 22.0593 7.50244 -20.9835 17.6314 -3301 4 50.9654 32.9474 22.4123 -1.20949 24.7473 -8.4765 -3302 4 50.362 33.6446 21.1779 1.66119 1.27804 -3.63001 -3303 6 18.1671 11.1714 14.3658 -12.4278 -6.78987 13.7569 -3304 4 18.0724 11.2679 15.338 -0.312443 2.59996 -20.4321 -3305 4 19.115 11.0923 14.227 4.83391 -0.924272 -3.79066 -3306 6 48.5058 14.2689 15.2513 -36.7782 -21.7282 -18.3567 -3307 4 49.3677 14.5693 15.4148 44.1026 10.3807 8.68918 -3308 4 48.5803 13.5893 14.5426 -8.44167 10.5166 12.8885 -3309 6 32.9801 15.74 8.25484 19.5805 1.81858 6.30948 -3310 4 33.8151 15.5666 7.78828 -7.72407 0.576521 2.61047 -3311 4 33.2057 15.7253 9.21147 -5.47651 1.26655 -15.0149 -3312 6 42.9141 4.85593 18.7596 35.6338 16.8786 18.3104 -3313 4 43.0674 5.82698 18.891 -14.0493 -22.2454 -3.89051 -3314 4 43.7794 4.50634 19.0974 -23.5505 0.71427 -17.3058 -3315 6 10.488 23.7131 33.4436 27.6073 45.1219 -14.7699 -3316 4 10.638 24.6985 33.3892 -15.3766 -28.1208 6.63949 -3317 4 11.1638 23.4099 32.8243 -6.46894 -14.1785 5.09081 -3318 6 1.12582 20.0662 11.2775 2.81918 8.09367 56.8435 -3319 4 0.488344 19.3589 11.407 -2.14544 -6.99577 -20.9797 -3320 4 1.17571 20.424 12.22 2.69463 -2.11621 -44.733 -3321 6 1.50824 39.5346 14.3079 -5.25271 -28.0543 15.9462 -3322 4 0.868346 40.1487 14.6984 3.61457 -0.641003 -8.28938 -3323 4 1.2571 38.629 14.6571 12.5115 33.2201 -10.0417 -3324 6 8.3332 21.6069 14.1357 -16.8636 -16.8509 36.8071 -3325 4 8.17334 21.0976 14.9962 5.25323 23.3985 -29.627 -3326 4 7.56323 21.4407 13.5807 -3.95337 3.79773 -2.56685 -3327 6 7.16177 13.3249 38.2255 -6.34169 -18.8056 -1.32195 -3328 4 6.69256 13.0329 37.4043 9.76156 12.0715 20.3406 -3329 4 7.43529 14.2522 38.1581 -0.0118119 -11.8895 -14.491 -3330 6 46.6212 1.64167 18.6867 -0.0463537 -24.1078 41.7639 -3331 4 47.541 1.5611 18.992 -0.862753 9.16913 -10.8716 -3332 4 46.1606 1.36736 19.5239 4.43612 14.9978 -24.7224 -3333 6 4.08147 8.39338 14.788 26.1694 13.8207 2.32184 -3334 4 3.41636 8.28931 15.4347 -29.1417 0.0985708 23.0338 -3335 4 3.90156 7.69349 14.1818 -2.47935 -14.3959 -27.3016 -3336 6 47.5712 36.5372 17.8422 14.6219 44.3363 14.3039 -3337 4 47.1691 35.7037 17.6938 -6.70251 -40.3849 -9.96305 -3338 4 48.5299 36.4434 17.8412 5.708 -14.7801 -1.83759 -3339 6 48.7177 32.6293 3.61477 24.5557 -7.82504 -30.2396 -3340 4 49.3183 32.0587 3.09719 0.221751 18.4164 7.83871 -3341 4 48.4066 32.0299 4.25286 -21.3126 -17.4552 36.5328 -3342 6 26.8672 34.4113 15.184 7.18591 -12.831 -4.85448 -3343 4 27.1806 33.7337 15.7866 -5.2278 -3.11582 5.08403 -3344 4 27.3382 34.1395 14.3734 -5.71629 20.1707 6.74573 -3345 6 9.99603 27.3398 13.3337 -11.5184 -70.0362 -20.4383 -3346 4 9.96963 28.1856 12.9595 -3.0362 48.3298 -16.8459 -3347 4 9.789 26.7159 12.5598 12.8825 26.2078 29.4693 -3348 6 2.39106 26.8936 37.3456 -18.0299 -5.48602 7.48259 -3349 4 2.24944 26.7597 38.2955 12.6258 0.126767 -1.18485 -3350 4 3.33209 26.9598 37.1993 18.2818 -0.192027 1.55797 -3351 6 33.3384 17.273 36.7956 -4.69576 6.00605 30.6641 -3352 4 32.3777 17.4022 36.9421 6.35755 -1.66054 -12.3647 -3353 4 33.5147 17.1107 35.8745 -6.55426 -0.461729 -19.8283 -3354 6 10.6704 18.7989 9.29568 -2.62714 4.796 -4.28658 -3355 4 10.7729 18.8103 8.31395 -3.57004 -0.312677 18.1362 -3356 4 10.9356 19.679 9.6198 -4.15772 -1.10699 -11.1079 -3357 6 8.58029 27.4085 3.13543 -0.646896 -38.9365 14.7517 -3358 4 8.62134 27.4642 4.10772 -2.35878 18.0768 -8.00568 -3359 4 8.54298 26.4189 3.06204 -3.80038 30.3142 -4.62402 -3360 6 40.6121 33.9148 14.3433 -13.4775 28.2536 -12.7531 -3361 4 40.8898 33.2957 14.9932 8.13038 -23.145 12.8628 -3362 4 40.1237 34.5547 14.8716 -1.64981 1.12342 -7.13376 -3363 6 54.0126 16.7742 13.6402 -25.2384 12.1291 10.4483 -3364 4 54.0311 17.2666 12.8352 12.7766 5.78776 -30.0788 -3365 4 53.1083 16.9555 13.9311 3.38038 0.740926 17.4694 -3366 6 39.1613 38.4947 7.40674 -49.2832 -1.36929 38.9537 -3367 4 38.8094 38.4839 6.52049 1.87105 5.40513 -14.0728 -3368 4 38.3203 38.5292 7.99504 41.7155 2.10662 -28.5328 -3369 6 42.2152 33.6749 29.0207 -49.4578 14.7313 -27.4402 -3370 4 42.0113 34.6279 28.8262 15.7605 -21.0767 3.4048 -3371 4 41.3749 33.2313 28.6743 34.021 9.03137 24.2205 -3372 6 2.84529 0.06018 20.1342 1.75144 -0.125494 -5.27144 -3373 4 2.85876 0.453048 19.2323 -10.3946 -7.40064 8.89792 -3374 4 1.95714 41.5787 20.3005 13.5701 9.63706 -6.70109 -3375 6 24.9846 26.9367 24.435 4.97654 17.1262 30.4362 -3376 4 25.3707 26.0628 24.5275 -2.48626 -13.7157 -10.817 -3377 4 25.1946 27.3852 25.2847 -1.69157 -3.92554 -20.3381 -3378 6 13.6202 33.989 7.00835 -29.3159 10.7937 -13.6787 -3379 4 14.4707 33.6317 6.76766 5.19255 -3.31821 -12.8703 -3380 4 13.1262 34.2356 6.16936 24.7045 -4.21039 25.9053 -3381 6 17.6361 31.8361 3.38698 11.6752 63.8731 -26.646 -3382 4 17.3765 32.06 2.46015 3.81419 -8.12146 27.658 -3383 4 17.5414 30.922 3.45915 -17.4061 -53.1647 5.72422 -3384 6 31.114 29.8463 35.9142 20.4735 12.0385 -23.871 -3385 4 30.4046 29.6578 36.4892 -25.9224 -10.1565 23.4082 -3386 4 31.8798 29.3863 36.2596 4.49336 -0.641295 3.24883 -3387 6 31.4544 1.69927 1.93203 61.0942 61.1307 23.4408 -3388 4 30.847 1.03155 1.81447 -56.5376 -48.8621 -2.33617 -3389 4 31.1234 2.33851 2.60628 -4.67927 -17.7811 -18.4359 -3390 6 13.7206 9.35179 12.308 -20.4886 -14.5553 22.3614 -3391 4 13.8994 10.2254 12.0406 16.2488 33.284 -13.5816 -3392 4 13.1923 9.47724 13.1212 6.47756 -14.062 -7.29461 -3393 6 15.2915 15.1706 12.1407 -39.3514 -20.6771 -15.8676 -3394 4 14.288 15.1355 12.0691 34.6095 3.19954 13.2467 -3395 4 15.5721 14.5705 11.433 2.70369 1.94224 0.817449 -3396 6 44.9298 30.4448 13.0945 -83.0621 -13.8007 20.4391 -3397 4 45.2326 30.6692 13.9612 22.7288 5.76966 14.7184 -3398 4 45.5619 30.4921 12.4362 58.1466 4.79773 -38.6719 -3399 6 35.1494 37.6283 24.8564 -28.9971 -18.9514 34.2227 -3400 4 34.5453 38.351 25.1691 15.7809 -12.2194 -9.31628 -3401 4 34.8969 36.8477 25.46 15.2444 28.3361 -22.0595 -3402 6 43.9018 19.2999 12.9893 -4.23684 -28.8047 14.7243 -3403 4 43.7111 18.3276 12.9437 8.07938 21.0179 -2.3859 -3404 4 44.434 19.3703 13.8064 -8.2748 4.27416 -6.23054 -3405 6 14.1928 27.3824 16.8974 17.9721 24.801 -15.5057 -3406 4 13.3941 26.8971 17.049 -12.9837 -13.2841 -1.45311 -3407 4 14.075 27.8458 16.0392 0.928992 -14.2323 10.6565 -3408 6 5.07867 37.4759 15.7278 -19.2695 5.34987 61.0101 -3409 4 5.83402 37.4907 16.3496 5.41141 -1.20808 -8.02024 -3410 4 5.40595 37.3511 14.8725 27.2981 -13.142 -45.6678 -3411 6 35.4792 36.9736 33.2279 -33.1303 3.22524 14.2013 -3412 4 36.4062 37.0387 33.1707 43.394 6.70104 -6.41693 -3413 4 35.2647 37.5361 33.9926 -10.1497 -5.08286 -5.32556 -3414 6 6.63713 31.7122 32.9951 -15.6769 -13.4095 -29.903 -3415 4 7.30356 31.0631 32.7808 0.413821 -11.0386 -1.85208 -3416 4 7.01801 32.1732 33.7097 9.96672 21.2943 24.541 -3417 6 31.2686 20.2272 25.4717 1.63607 -11.2998 14.888 -3418 4 30.457 20.1188 26.0175 18.7046 8.55246 -6.40474 -3419 4 30.9671 20.3507 24.5747 -9.02709 8.2981 -6.80006 -3420 6 54.9594 26.0897 7.3541 -26.2324 -3.52234 4.1817 -3421 4 54.3149 26.536 6.76189 8.45344 -4.14623 9.81761 -3422 4 54.4064 25.6921 8.06559 9.60693 6.10548 -13.0393 -3423 6 17.8786 35.1581 24.3912 -48.4608 -31.2574 -23.2844 -3424 4 17.9034 34.576 25.1672 15.4891 12.513 -1.90366 -3425 4 17.14 34.695 23.8716 34.0055 23.8611 10.1154 -3426 6 49.1404 3.30993 19.753 -11.7437 -5.45724 -22.9314 -3427 4 48.7379 4.07245 20.162 -0.785462 12.6857 6.5087 -3428 4 49.8408 3.03849 20.3377 4.84054 -6.57183 8.59361 -3429 6 30.2791 35.6014 13.4902 -0.275976 1.62471 9.45881 -3430 4 29.4038 35.7322 13.1068 5.01216 -3.78726 -8.18413 -3431 4 30.1007 35.4484 14.4302 1.26073 -0.50544 -4.60872 -3432 6 43.3857 25.8788 41.6729 -28.3599 -13.2186 -4.43344 -3433 4 44.0236 25.6058 41.0289 13.0372 -2.28568 -15.7328 -3434 4 43.8192 26.4334 0.378509 18.4346 21.3926 23.5205 -3435 6 21.1033 23.1572 6.40534 -12.8895 6.60285 13.2505 -3436 4 21.2833 23.9599 6.94372 3.68538 -20.4677 -7.26612 -3437 4 21.2354 23.4378 5.50624 8.61756 6.39287 -19.4039 -3438 6 54.6209 21.1977 19.0953 -9.4905 16.5472 15.3455 -3439 4 0.355231 21.543 19.6762 -10.082 -5.94448 -19.8865 -3440 4 53.803 21.6498 19.4211 22.178 -8.62035 -3.94206 -3441 6 13.8696 38.9444 18.7589 -0.408574 -9.95072 10.686 -3442 4 13.5473 38.5195 19.5701 -4.79749 -3.34053 -10.6661 -3443 4 14.2783 39.7511 19.0654 -4.68159 17.5572 -2.41189 -3444 6 39.1837 2.73799 39.6933 -2.22487 -14.248 -19.2211 -3445 4 38.5048 2.18054 40.1045 3.50502 9.25929 9.72195 -3446 4 39.1752 2.3966 38.7788 -3.09486 7.3066 6.14055 -3447 6 43.2236 33.8218 8.83748 -23.7799 54.6507 -8.87946 -3448 4 43.1776 32.9835 9.22653 -2.14792 -45.6212 21.4927 -3449 4 42.4318 34.327 9.18683 27.5752 -12.6709 -4.85681 -3450 6 23.0768 16.6786 12.1043 19.2201 -8.5648 -22.0864 -3451 4 23.4688 16.2415 11.3109 -7.42341 7.06352 19.0042 -3452 4 22.1329 16.714 11.9048 -3.02708 6.60369 6.72608 -3453 6 40.7875 26.1445 36.3165 -31.0446 26.1707 15.63 -3454 4 40.1182 26.8831 36.2336 22.2291 -27.8038 4.66075 -3455 4 41.0346 25.9172 35.4285 12.0382 -0.567557 -16.236 -3456 6 15.1503 11.6728 19.298 -10.8743 -20.3409 15.6657 -3457 4 15.4707 12.2619 18.6272 13.0208 17.9076 -10.0848 -3458 4 15.518 11.9699 20.1418 -0.780585 5.28883 -4.88637 -3459 6 9.8485 29.8084 31.3808 31.6725 31.0987 -15.032 -3460 4 10.6075 30.172 31.8684 -9.75043 -12.6573 12.7307 -3461 4 9.98584 30.2945 30.5336 -20.1344 -22.7331 8.89086 -3462 6 2.12557 30.0341 25.264 -3.96851 -24.8252 -11.595 -3463 4 2.04755 29.1979 25.7442 2.8488 12.5065 4.07713 -3464 4 2.06741 29.7398 24.3306 5.27272 21.1251 20.17 -3465 6 49.0124 10.6515 7.04668 12.8278 -6.79775 19.6819 -3466 4 49.7765 10.456 7.62014 -4.12072 9.88663 -9.32692 -3467 4 48.4954 9.84699 7.16976 -12.5497 -3.43755 -7.74842 -3468 6 38.6385 34.4247 32.4851 8.7415 15.3068 2.26745 -3469 4 38.2449 35.2411 32.8392 7.79483 -2.42751 -9.0272 -3470 4 38.3877 33.7513 33.1114 -5.41613 -8.85245 5.88093 -3471 6 24.2967 24.7175 4.7858 -13.8074 20.2372 -8.25903 -3472 4 24.5879 23.8747 5.12331 8.49271 -10.4438 10.0312 -3473 4 24.0688 25.3355 5.52385 7.10746 -21.4288 -14.6014 -3474 6 44.0211 23.587 33.7713 -18.8641 -18.6234 -6.9532 -3475 4 43.6265 23.0569 33.047 -3.30007 6.44469 22.3225 -3476 4 44.7839 23.9213 33.3479 32.8249 22.1868 -7.88886 -3477 6 45.135 31.9539 26.6318 17.8742 -16.5206 -32.2352 -3478 4 44.6965 32.0125 27.458 -12.8805 4.46476 28.7394 -3479 4 45.0195 31.023 26.337 -1.34861 17.8758 10.4404 -3480 6 52.0545 6.36303 22.865 -1.87051 -30.929 -4.90791 -3481 4 51.4549 5.58836 23.0553 13.7734 29.2588 0.606927 -3482 4 51.4955 7.14596 22.8951 -3.5837 -3.73437 -5.39564 -3483 6 5.1124 17.7016 30.4663 -17.3022 -2.39818 -4.94531 -3484 4 5.57517 17.705 29.6436 5.33167 -14.42 -26.4334 -3485 4 5.6774 18.2653 30.9495 12.7188 16.8745 32.2475 -3486 6 48.5399 17.0091 6.52669 31.3107 25.6813 -22.3666 -3487 4 48.2466 16.108 6.56632 -4.44525 -18.5722 0.0807757 -3488 4 49.3123 17.0767 5.87973 -32.0368 -4.22047 21.2267 -3489 6 13.8017 31.3286 23.4652 -45.3568 -0.340859 23.461 -3490 4 14.0246 31.2001 24.3905 13.6426 -1.74144 -0.768444 -3491 4 14.5269 31.1963 22.8948 44.8358 -8.96568 -14.3918 -3492 6 28.4984 33.4231 26.025 30.2115 45.129 -4.70205 -3493 4 28.7629 32.7421 25.4284 0.749934 -18.6264 -12.7861 -3494 4 27.7356 33.1626 26.4825 -33.9251 -20.2776 22.3239 -3495 6 9.04101 22.9533 11.0101 4.17271 5.63899 8.67886 -3496 4 9.24243 22.776 10.0879 9.05926 -1.29962 -0.957415 -3497 4 9.84172 22.774 11.5341 -6.79246 0.647577 -9.3095 -3498 6 40.5624 4.0706 26.5792 43.7479 -58.1273 15.512 -3499 4 40.0377 4.03321 27.356 -14.6911 0.39925 31.4188 -3500 4 40.1771 4.74143 26.1095 -33.6389 57.2603 -43.6855 -3501 6 17.0606 37.9689 20.9328 24.9068 -2.83666 19.2437 -3502 4 17.7492 37.7057 21.5806 -0.23423 0.332892 -22.3637 -3503 4 16.3 37.9671 21.4825 -28.3901 -0.1668 6.57955 -3504 6 31.9758 6.36253 14.1925 -47.1359 -2.961 8.2158 -3505 4 31.6652 5.47044 14.4516 -0.57512 5.53961 -9.89258 -3506 4 32.9075 6.27907 14.242 33.1863 -3.34593 -3.73058 -3507 6 29.3613 34.9484 39.6522 -7.7658 6.78361 -10.4711 -3508 4 29.4154 34.7255 40.5688 2.48129 -3.65799 19.6008 -3509 4 28.4079 35.1232 39.5563 9.75382 -5.50564 -9.65046 -3510 6 22.5642 2.93231 32.1024 7.89654 -13.571 4.24933 -3511 4 23.152 3.60479 31.7467 -0.797152 8.5773 -0.128413 -3512 4 22.8746 2.10235 31.6905 -8.86372 14.3523 0.842504 -3513 6 51.7365 19.0888 24.8036 24.4352 10.6631 34.2631 -3514 4 52.2011 19.3182 25.6664 -22.8444 -5.9403 -33.5217 -3515 4 52.2256 19.5376 24.1035 -3.13425 5.18677 -1.50107 -3516 6 32.1309 13.661 24.2221 8.32979 -1.22201 -48.3483 -3517 4 32.1718 13.7834 25.1379 3.34806 7.10631 53.6256 -3518 4 31.2192 13.5434 23.9915 -25.9097 -1.66347 2.1781 -3519 6 9.49478 30.1756 28.7975 -1.02802 7.68553 8.51386 -3520 4 8.9614 29.4447 28.4635 3.13242 -3.87437 -3.11369 -3521 4 9.76139 30.7024 28.0341 -4.99689 -6.39164 -2.13333 -3522 6 31.3017 3.1328 24.0821 -2.56057 -13.3126 7.41322 -3523 4 30.8642 3.97896 23.9468 1.03353 -0.10231 -3.56587 -3524 4 32.1597 3.13825 23.6386 1.18226 10.803 -0.447916 -3525 6 2.13915 19.8328 36.4477 43.9795 26.8161 3.66972 -3526 4 3.0929 19.9274 36.115 -41.9598 -16.8793 8.64164 -3527 4 1.76662 18.9777 36.2517 -5.24508 -9.86619 -11.2286 -3528 6 36.9558 16.7701 14.0992 8.10199 -24.1685 -1.60142 -3529 4 37.0878 17.1202 14.9938 -3.44507 3.84646 -3.58016 -3530 4 37.3137 15.854 14.1066 -5.27996 15.1268 -1.92478 -3531 6 1.82451 11.1811 6.08431 4.75441 9.84221 -14.5701 -3532 4 1.68522 10.3449 6.52934 -2.64515 -5.74712 4.44833 -3533 4 1.45572 11.848 6.66197 -6.16769 2.71123 7.45582 -3534 6 43.1467 36.8536 25.2684 -4.34259 -25.2275 5.76074 -3535 4 42.489 36.6679 24.5813 -1.65581 9.08703 8.09798 -3536 4 42.9757 36.1566 25.9418 7.67001 18.3814 -10.5814 -3537 6 32.1358 5.54258 7.00813 -0.159667 5.03525 -3.02009 -3538 4 31.8447 4.70695 7.37259 1.76357 -8.94122 3.22744 -3539 4 31.6184 6.21523 7.45425 -7.92944 5.35442 3.67752 -3540 6 15.0738 21.498 41.5176 2.48253 -6.99424 4.64434 -3541 4 14.4083 21.441 0.286083 -5.89506 -4.91034 13.0846 -3542 4 14.6326 22.02 40.8608 1.523 7.8898 -22.5967 -3543 6 37.0299 36.0573 5.68999 -1.26402 -4.33671 -4.68257 -3544 4 36.8992 36.8706 5.1864 -9.04185 9.38437 4.54051 -3545 4 36.6368 36.1345 6.57983 4.68584 5.64444 -6.17041 -3546 6 39.6378 22.8733 0.344261 -10.4835 1.90991 -1.04201 -3547 4 39.8967 23.7127 41.8596 6.32696 2.65577 1.7872 -3548 4 39.7641 22.9598 1.30287 2.84221 -4.68177 2.22816 -3549 6 18.471 23.1695 5.24444 18.17 13.8994 5.32385 -3550 4 18.2426 24.0888 5.07969 -12.1406 8.45165 -11.681 -3551 4 19.3434 23.2774 5.65727 -5.17221 -14.3673 2.51868 -3552 6 34.4951 26.4012 0.415196 -24.2262 -21.8504 23.5375 -3553 4 33.9567 27.1096 0.873351 15.2264 -25.8266 -5.88921 -3554 4 34.3584 25.5285 0.919462 6.17703 40.7497 -12.3351 -3555 6 28.1538 26.089 40.6186 -44.0465 -12.7539 23.8091 -3556 4 29.0676 25.9468 40.8623 9.74545 0.451611 8.45277 -3557 4 27.5517 25.6856 41.3354 31.2048 15.0133 -28.9196 -3558 6 41.7541 4.40312 30.2348 -21.1804 7.97019 15.7848 -3559 4 42.5951 3.9554 30.1474 10.5948 -6.90465 6.49815 -3560 4 41.6197 4.66064 31.1807 9.39609 -4.15263 -13.0838 -3561 6 4.45746 8.30422 29.123 17.0584 8.0822 12.8675 -3562 4 3.72424 8.78851 28.7689 -20.5564 0.917363 -10.5697 -3563 4 4.90241 9.00738 29.631 2.39094 -12.8625 -4.67793 -3564 6 12.9051 9.61174 32.1485 9.54391 19.7002 1.20842 -3565 4 12.5238 8.90328 31.6499 -4.6135 -18.7028 0.941221 -3566 4 13.4507 9.29961 32.8815 -5.77341 -6.01915 -0.606497 -3567 6 48.6524 16.2364 1.45279 -39.5117 19.3379 22.5337 -3568 4 49.5656 16.3395 1.57323 44.82 -2.42546 -4.76282 -3569 4 48.322 16.6449 2.29127 -2.06599 -18.2277 -23.678 -3570 6 26.4391 39.9942 21.1964 -5.73 55.7886 4.05886 -3571 4 27.1886 40.6225 21.0926 -13.7426 -7.13397 8.25982 -3572 4 26.7825 39.1793 20.9147 12.833 -38.7313 -7.54244 -3573 6 35.8074 4.09236 9.03492 -45.4698 -15.3304 -15.5709 -3574 4 35.5046 4.67089 8.30824 2.24043 1.80806 6.22839 -3575 4 34.9768 3.81452 9.52186 26.5657 10.3238 -8.47709 -3576 6 52.6895 3.55751 27.8666 50.2867 -19.9176 -34.5196 -3577 4 53.5586 3.5996 28.3549 -33.5645 -3.53647 -1.9565 -3578 4 53.0019 3.22463 26.9489 -24.4009 21.759 36.9675 -3579 6 48.3192 26.6913 27.3954 13.1896 -37.7442 -6.45526 -3580 4 48.9722 25.929 27.4853 -22.116 34.446 0.770506 -3581 4 48.7243 27.4862 27.7371 6.43066 9.80699 11.7315 -3582 6 24.507 4.96042 18.7259 -17.59 -10.4057 14.9036 -3583 4 24.0519 4.20246 19.1729 14.2279 16.3534 -10.8515 -3584 4 23.9406 5.7442 18.8517 8.31711 -9.56192 -0.149656 -3585 6 24.0493 12.473 28.7688 20.4432 11.2466 2.34496 -3586 4 23.2439 12.9627 28.9427 -11.3477 -3.77152 -2.6943 -3587 4 23.8404 11.6087 28.4204 -6.74951 -3.90152 -5.01594 -3588 6 40.1637 27.7353 40.8087 -33.5791 -9.4694 0.953173 -3589 4 40.5641 26.9832 41.236 1.78301 2.25495 0.260865 -3590 4 39.2218 27.4214 40.7917 21.7476 20.7917 -9.34619 -3591 6 11.9335 13.5538 26.9488 -1.21599 4.57236 -11.9259 -3592 4 11.0364 13.8177 27.1576 -7.67129 -6.9102 2.53909 -3593 4 12.2164 12.9501 27.6309 4.70555 -13.4351 6.55277 -3594 6 52.1924 29.5424 41.3942 11.5626 -24.8936 -19.0003 -3595 4 51.8104 30.1965 0.050158 4.44506 23.3375 14.6186 -3596 4 53.1351 29.3771 41.6391 -10.5303 1.44862 4.74126 -3597 6 17.4882 19.0285 39.1853 -8.07927 32.7478 0.0743051 -3598 4 17.5012 19.6463 39.9647 -0.891206 -23.8414 -20.0908 -3599 4 17.261 19.5796 38.3923 8.05332 -16.519 21.1694 -3600 6 46.2326 27.6801 33.704 6.45393 -8.86534 7.23017 -3601 4 46.097 28.3723 33.048 -4.6559 5.79968 -1.93617 -3602 4 45.5979 27.7746 34.4233 -3.33861 16.4707 5.34235 -3603 6 35.8364 29.5448 5.62541 9.64171 -18.9009 -6.27826 -3604 4 35.5566 29.3199 4.72548 3.62776 14.0584 -3.56087 -3605 4 35.3944 30.354 5.86953 -6.57081 16.5188 2.47276 -3606 6 47.2881 25.7744 30.172 -6.62968 25.0044 -44.0548 -3607 4 48.1218 25.8653 29.6696 -5.94381 -7.49802 14.0131 -3608 4 46.6882 26.3745 29.6449 8.85802 -15.1094 17.4745 -3609 6 51.3842 12.359 20.0239 24.4626 17.3052 -5.31346 -3610 4 50.8707 12.833 19.3583 -10.0057 -7.98386 3.51527 -3611 4 50.8448 11.6564 20.3722 -11.0446 -8.70835 7.6307 -3612 6 41.976 18.3776 28.9581 25.2971 -7.26912 -18.3725 -3613 4 42.7018 17.9973 28.405 -17.3573 7.64094 3.96866 -3614 4 42.4517 18.9921 29.5246 -2.74764 -0.293653 0.793262 -3615 6 53.6043 6.48027 7.50524 -23.0657 -32.6432 -30.9738 -3616 4 53.1601 5.59498 7.33399 18.2827 28.6912 7.08019 -3617 4 53.6632 6.576 8.44633 9.6706 -3.87944 16.2616 -3618 6 9.90786 10.6094 26.7582 6.17728 8.73826 28.1859 -3619 4 10.299 10.3755 27.6331 -6.59671 -6.24018 -20.7073 -3620 4 9.65116 11.5299 26.9247 0.732239 -5.98194 -12.944 -3621 6 9.31054 39.3957 29.7756 40.7644 23.7808 19.8799 -3622 4 10.1982 39.3563 30.2561 -34.3316 0.809436 -14.8313 -3623 4 8.83679 40.1565 30.1832 5.55001 -15.1294 -12.8037 -3624 6 33.4099 4.77839 0.03236 -17.6047 -18.7695 14.8321 -3625 4 33.6454 5.53147 41.4176 15.8926 12.9618 -7.52592 -3626 4 34.0969 4.09847 41.8942 -0.186489 10.0102 -3.03658 -3627 6 35.7116 10.6673 34.2398 36.7653 -21.2814 -15.2586 -3628 4 35.2554 10.867 35.0388 -18.8422 0.575424 27.4634 -3629 4 36.4577 10.0619 34.4978 -21.6361 17.9445 -5.28322 -3630 6 15.2039 17.4016 19.1867 13.7018 -34.0248 -48.7675 -3631 4 15.5709 16.9982 18.3093 -23.7907 16.5473 43.0322 -3632 4 14.2523 17.472 19.021 -2.02403 4.48523 -0.714523 -3633 6 17.4757 37.6682 15.4227 -5.7624 0.927264 51.2416 -3634 4 17.0409 37.838 16.3209 3.67045 -5.85113 -35.7653 -3635 4 18.3529 37.3927 15.7202 1.879 4.38305 -13.464 -3636 6 26.263 8.20496 21.7043 -12.9193 13.0258 38.8746 -3637 4 26.2935 8.46487 22.6678 13.4631 -3.74504 -28.0146 -3638 4 25.3122 8.09558 21.5911 -4.90698 -1.77416 -12.6216 -3639 6 0.327844 9.89683 15.4174 -28.4002 -4.57955 -27.8061 -3640 4 1.20252 9.6859 15.1701 33.2298 -8.84956 3.25601 -3641 4 54.8213 9.3498 14.7471 -0.695723 21.8052 24.8209 -3642 6 13.451 40.6616 9.29616 -29.1589 -29.1317 3.11657 -3643 4 12.531 40.2581 9.2528 27.9164 27.237 1.6895 -3644 4 13.9533 39.998 9.7876 1.76749 3.89663 -1.50565 -3645 6 49.5605 25.9144 33.0102 6.77982 -23.7672 54.8124 -3646 4 50.0733 25.5846 33.8473 -25.1648 19.9091 -52.5505 -3647 4 48.6275 25.6453 33.15 14.5478 0.915879 -9.46863 -3648 6 37.0796 40.0419 26.4359 -26.9931 13.9721 12.3681 -3649 4 36.1882 39.5442 26.6099 42.8933 36.2545 -2.50818 -3650 4 37.051 41.026 26.6764 -12.8506 -44.3362 -9.04112 -3651 6 47.9916 17.8545 12.1553 -7.21137 29.6324 -37.7219 -3652 4 47.6652 18.6843 11.7058 6.42171 -29.0319 9.52509 -3653 4 47.7397 17.941 13.056 -8.12129 -2.80141 29.1943 -3654 6 27.9724 29.0571 34.165 6.45289 -21.5611 -2.40729 -3655 4 28.8948 28.8211 34.3683 -10.3018 1.8492 -2.91154 -3656 4 27.944 30.0064 34.1676 -0.713497 24.9251 0.854011 -3657 6 33.997 2.77014 13.2231 -35.3168 39.3397 6.14274 -3658 4 33.7592 2.40426 14.0871 -4.38792 -6.80294 -4.34532 -3659 4 34.7545 2.32608 12.931 40.4814 -27.3629 -5.76242 -3660 6 28.4454 36.033 11.4537 -30.811 -5.98685 22.1865 -3661 4 27.9997 35.3658 10.9161 0.521783 -1.73573 4.3727 -3662 4 28.9676 36.474 10.8303 31.7187 19.1344 -28.008 -3663 6 36.1836 11.3675 28.8638 -20.2526 -8.96451 -46.9053 -3664 4 35.201 11.3136 28.8426 17.393 5.15327 13.3727 -3665 4 36.3619 11.2493 27.8855 5.85658 3.26624 29.9739 -3666 6 24.7946 39.4802 16.9069 19.0937 3.96627 -8.4872 -3667 4 24.3751 40.345 16.9988 -5.97342 -3.52606 0.908874 -3668 4 24.9466 39.3518 15.9585 -10.9099 3.48913 2.54936 -3669 6 49.9504 8.05659 22.8451 -38.4139 -9.47108 -34.4931 -3670 4 49.9375 7.9588 23.7925 -16.1787 -3.75115 16.4902 -3671 4 49.0231 7.8493 22.4633 39.8101 3.17892 24.2331 -3672 6 52.1004 19.3469 10.2236 -1.12118 28.0811 1.24376 -3673 4 51.6057 19.3908 9.40186 -4.74475 -17.9853 -5.36861 -3674 4 52.3066 20.3081 10.2872 8.90847 -30.6944 7.30622 -3675 6 24.8344 15.8907 6.13046 -10.5287 3.62194 6.20212 -3676 4 24.2343 16.3288 6.78807 10.5214 -9.32926 -18.7028 -3677 4 24.4584 16.0701 5.24836 4.34413 4.47582 9.48796 -3678 6 49.3142 23.7074 8.6354 12.7826 -64.5552 32.8663 -3679 4 49.2168 22.9153 9.25307 13.1077 36.9849 -24.4484 -3680 4 48.4233 23.9587 8.46247 -20.5325 16.4959 -12.9251 -3681 6 0.200228 10.6387 32.1899 4.57462 9.08702 -50.3173 -3682 4 1.12405 10.3631 32.1441 4.84637 -6.06001 20.7538 -3683 4 54.8206 10.7585 33.0477 -1.25869 -8.0958 33.7963 -3684 6 12.5866 32.9145 13.2359 -45.84 -1.33101 12.3773 -3685 4 11.7384 33.4448 13.1799 26.1773 -16.8128 -1.90055 -3686 4 13.2757 33.4614 12.9111 20.4647 17.7705 -9.07485 -3687 6 21.729 32.5695 14.1172 -9.28791 -20.3928 5.37861 -3688 4 21.166 33.3661 14.1597 2.78901 -9.86158 3.94413 -3689 4 21.3002 31.8069 14.587 7.27427 31.5827 -10.8786 -3690 6 48.1522 34.8482 27.3304 1.15431 -17.6089 -40.5894 -3691 4 47.5385 35.1725 27.9994 -6.04073 -2.93057 -0.479876 -3692 4 47.6796 34.4132 26.5454 8.99615 21.2578 35.6726 -3693 6 45.6357 31.2393 36.095 -40.8957 20.4658 25.2026 -3694 4 45.8476 31.9489 35.493 1.2761 6.76392 -14.6383 -3695 4 44.8829 31.5945 36.6582 19.8537 -10.4851 -18.3708 -3696 6 46.2846 0.316369 14.3569 -23.6541 -29.5796 11.0344 -3697 4 46.2347 1.24867 14.1822 6.12226 14.592 -0.646978 -3698 4 47.172 41.8876 14.3137 22.6277 5.76419 -11.0491 -3699 6 14.3437 18.9821 40.2104 -25.2995 -33.3041 -15.9392 -3700 4 14.4094 19.2869 39.3238 4.54227 2.45102 -23.4893 -3701 4 14.593 19.7098 40.7196 18.3341 34.8836 33.2243 -3702 6 14.5595 1.13832 10.2184 21.0915 11.237 11.4523 -3703 4 15.4791 1.15983 9.85648 -24.9846 -0.242798 0.374642 -3704 4 14.0639 0.416501 9.81608 3.47586 -8.24251 -5.69878 -3705 6 34.4238 40.9137 13.0059 -4.24882 -26.6665 -25.0696 -3706 4 34.0907 40.4301 12.2099 6.6876 25.2293 12.1693 -3707 4 34.3655 40.2093 13.6737 -1.45879 20.9599 -0.365544 -3708 6 42.1372 25.6317 33.9946 32.9644 -29.1434 -4.32848 -3709 4 41.7256 25.3671 33.1599 -4.34041 1.82357 5.58197 -3710 4 42.8775 24.9612 34.1276 -26.6125 21.4128 -4.76888 -3711 6 29.2041 22.5904 40.0709 -12.2401 -3.24737 -11.2113 -3712 4 28.5312 23.0545 39.5673 2.40343 6.95864 -1.48823 -3713 4 29.0042 22.7646 40.9807 1.44808 0.219743 17.343 -3714 6 44.8039 18.6198 1.5029 3.83338 16.5679 14.3409 -3715 4 44.9659 19.0204 2.39019 -3.90529 -17.866 -14.3425 -3716 4 44.0478 19.1074 1.16429 2.25905 3.06151 -3.31671 -3717 6 4.48486 10.8191 23.9456 -47.6019 -35.9978 3.19751 -3718 4 5.13394 11.3869 23.6113 33.8353 31.137 -11.4748 -3719 4 4.52769 10.7271 24.8961 2.68899 9.9192 5.78369 -3720 6 6.46393 23.0191 29.0034 23.802 4.69353 23.6764 -3721 4 7.14249 23.0161 29.7285 -18.6834 17.7038 -21.9419 -3722 4 6.49076 22.0968 28.8008 -10.0115 -22.5628 -12.4771 -3723 6 39.7912 25.1434 32.5739 17.5205 -18.6836 -60.5647 -3724 4 39.6128 25.3468 33.4485 -16.6712 22.7672 53.7369 -3725 4 39.6667 25.9357 32.0325 -1.3786 -0.359445 4.68486 -3726 6 40.844 21.4875 8.87812 10.6958 -1.16061 -24.4784 -3727 4 40.753 21.3778 7.91779 -6.86728 3.07162 8.13114 -3728 4 41.3272 20.6946 9.13123 4.7165 -6.17308 11.2164 -3729 6 0.614957 1.42802 12.9561 35.282 30.4207 -35.1483 -3730 4 54.8795 1.90166 12.5287 -4.84596 -15.7095 11.3484 -3731 4 0.325279 0.716474 13.4972 -22.2917 -16.9379 18.816 -3732 6 32.6687 29.7155 23.4821 0.172893 -14.8348 21.3896 -3733 4 32.2937 28.8037 23.5347 8.27316 18.2339 -7.75927 -3734 4 32.5776 29.9928 22.5742 -5.86304 -0.191283 -15.879 -3735 6 12.5314 37.1515 20.4729 45.6241 64.5302 32.6184 -3736 4 13.0675 37.1561 21.3077 -14.1528 -0.638655 -18.1117 -3737 4 12.0966 36.3476 20.454 -27.4762 -63.6198 -6.10217 -3738 6 13.8924 14.5151 24.69 -3.15938 -4.02598 20.115 -3739 4 13.491 15.2498 24.2338 -4.44789 9.69439 -9.34194 -3740 4 14.0279 14.8194 25.6039 -0.281954 0.872924 -9.09093 -3741 6 17.5021 27.063 26.4741 18.9499 -7.93165 -17.7551 -3742 4 17.3645 27.9616 26.0981 5.20292 -20.1733 2.46217 -3743 4 18.105 26.551 25.8503 -19.0729 23.9469 15.4793 -3744 6 54.4877 9.53021 26.3477 -5.78247 7.96784 25.4661 -3745 4 54.0512 10.3733 26.628 8.34027 -15.1138 -9.49744 -3746 4 54.8923 9.139 27.1544 -8.60221 9.32804 -13.3813 -3747 6 33.6807 21.5011 24.9225 20.8165 12.7411 -37.5161 -3748 4 33.6447 21.5342 23.9109 -0.857654 -11.0597 35.2787 -3749 4 32.8481 21.1477 25.2212 -19.5227 -6.82771 5.56304 -3750 6 22.1475 35.2701 2.885 -1.57378 -2.18642 30.1771 -3751 4 22.1887 34.3602 2.5781 3.09514 -3.18559 -9.19859 -3752 4 22.1072 35.1817 3.87164 0.12039 0.813186 -18.6146 -3753 6 45.3027 5.41438 15.6133 24.4211 -32.124 17.7203 -3754 4 45.2073 5.06649 16.5292 -4.89018 16.6426 -14.7318 -3755 4 44.541 5.92364 15.3615 -17.3903 4.72304 -1.03383 -3756 6 5.67534 7.5869 16.981 -5.47297 6.8358 -20.2139 -3757 4 5.25896 7.81046 16.1225 6.35918 -0.232773 12.9215 -3758 4 6.51331 8.07041 16.9918 4.7107 -6.94883 2.60141 -3759 6 34.576 39.0992 27.2053 24.5889 13.5844 -33.9491 -3760 4 34.3093 38.4547 27.8221 -16.0328 -19.2876 29.327 -3761 4 34.0621 39.904 27.3046 -7.96056 4.01318 13.6593 -3762 6 32.7541 33.6107 34.2903 -12.2088 11.6467 -22.6039 -3763 4 32.1008 34.0277 33.6489 27.9813 -13.6615 23.3944 -3764 4 32.6574 34.0489 35.1447 -11.8345 -0.637226 -0.957772 -3765 6 31.0088 41.2052 32.3952 -16.5884 -4.13679 -5.08533 -3766 4 30.2065 41.1942 32.9317 -1.71273 -1.00977 6.80252 -3767 4 30.9738 0.147898 31.9828 5.47722 15.337 -6.15299 -3768 6 7.65161 1.58314 27.1492 34.9115 -9.04616 -23.8477 -3769 4 8.49581 1.43905 26.61 -35.9655 -7.00487 18.1392 -3770 4 7.51162 2.51613 27.0476 -4.48076 16.5289 1.77021 -3771 6 0.884173 22.0999 37.8474 19.5684 -22.3581 -15.9684 -3772 4 1.29289 21.3236 37.3582 -15.3878 24.821 16.8607 -3773 4 1.19208 22.8872 37.3739 -1.97361 -3.14502 -0.467946 -3774 6 7.41204 11.1157 19.2314 -38.1481 -15.0427 -1.85178 -3775 4 7.53858 12.0593 19.2468 12.5581 17.6457 8.19935 -3776 4 8.2604 10.6916 19.3015 17.9889 5.14781 -4.65775 -3777 6 43.7858 12.4956 37.3097 0.920036 9.73958 -3.1733 -3778 4 43.9612 12.5094 36.3537 -0.436236 -2.21513 6.60981 -3779 4 44.6264 12.7918 37.692 -0.443403 -7.75914 -0.361508 -3780 6 29.0868 33.5248 36.1867 6.33086 18.8505 -43.8567 -3781 4 29.87 33.99 35.8176 -18.9328 -5.41066 10.4629 -3782 4 29.4633 33.0358 36.8874 15.3521 -14.5291 31.9885 -3783 6 14.802 4.59099 3.93345 20.4849 22.8827 12.2406 -3784 4 14.3757 4.0439 3.27797 -5.14737 -6.71868 -8.73832 -3785 4 15.6594 4.91612 3.57855 -16.4986 -14.1515 -5.85747 -3786 6 39.0551 6.39795 6.38864 -31.6963 1.09254 42.8867 -3787 4 39.3692 7.21691 6.04781 17.6944 18.3081 -17.2196 -3788 4 39.3538 5.69048 5.84285 10.6785 -8.50098 -20.4551 -3789 6 22.2123 37.9977 40.776 -14.7699 -23.2033 -28.4168 -3790 4 22.4586 38.8695 40.5021 9.68098 25.7962 -2.3277 -3791 4 22.4791 37.9118 41.6765 7.85923 -2.07179 26.9545 -3792 6 4.44877 23.2867 6.14309 -1.92846 -21.7963 14.7751 -3793 4 3.85981 23.8785 6.59389 -8.34079 22.3777 -5.30491 -3794 4 4.15148 22.4458 6.53602 18.5324 -1.87236 -10.5169 -3795 6 12.4298 23.7885 9.24819 15.5635 1.24594 19.7483 -3796 4 11.6299 23.5219 8.81427 -22.2296 0.449899 -3.14002 -3797 4 12.2156 24.1823 10.1208 2.55292 -1.37139 -18.7826 -3798 6 46.4922 15.2589 16.9667 3.22745 3.94864 2.0367 -3799 4 47.1791 14.9867 16.3488 -1.59454 -10.7105 -10.6804 -3800 4 46.8221 16.1143 17.2497 1.89409 2.98219 12.0057 -3801 6 34.1117 27.1644 19.7797 24.4736 -11.2812 21.2279 -3802 4 34.8774 26.5238 19.7962 -19.6491 14.1094 -6.20677 -3803 4 34.0324 27.4806 20.6991 -2.21978 -4.312 -16.0235 -3804 6 46.9479 13.2121 35.1109 14.7829 18.0264 15.8687 -3805 4 47.3232 14.0654 34.8894 8.1348 3.75559 6.81177 -3806 4 46.5576 12.9943 34.2929 -17.7211 -19.0679 -23.646 -3807 6 50.5883 18.7922 12.536 -4.97475 -8.40096 -18.6689 -3808 4 49.7377 18.4417 12.2063 9.85466 0.19572 8.20723 -3809 4 51.2037 18.6585 11.7837 -7.44169 10.1395 9.07394 -3810 6 32.4871 12.6357 31.9554 3.75694 -28.5712 -45.9238 -3811 4 32.607 11.6542 31.8864 5.47128 21.8321 9.55763 -3812 4 32.4011 12.8494 32.8587 -4.02679 2.16968 41.7104 -3813 6 6.20502 19.6778 10.0162 1.71901 21.9334 16.0314 -3814 4 6.41826 20.2441 9.25697 6.75258 -1.0862 1.44387 -3815 4 6.08129 20.3112 10.7738 2.93045 -16.0896 -19.0741 -3816 6 21.5254 21.5246 2.44441 10.1652 3.23891 -24.6245 -3817 4 21.7373 21.5014 1.49425 -3.90993 5.22039 4.49463 -3818 4 22.0841 20.8004 2.76184 -10.1442 1.98878 12.5692 -3819 6 38.3901 23.0895 17.1987 11.9637 -29.1373 -23.0023 -3820 4 38.7115 23.1739 16.2902 2.30233 23.4463 5.8212 -3821 4 38.6091 22.1461 17.2941 -10.4226 8.48715 23.8901 -3822 6 29.6992 24.9636 22.2212 38.6917 -37.4999 -9.7813 -3823 4 30.2244 25.0209 22.9989 19.9484 -5.9881 25.7874 -3824 4 29.0295 25.5321 22.4534 -63.588 46.0104 6.14599 -3825 6 30.2959 21.4331 37.7732 -36.6703 24.7369 -1.55525 -3826 4 30.3833 21.3736 36.7928 -5.6984 1.01251 23.2154 -3827 4 29.3642 21.7906 38.031 44.833 -25.8334 -23.6526 -3828 6 11.8968 11.712 16.3062 -52.2626 -16.509 -42.1992 -3829 4 11.3487 12.2512 16.8737 -4.04714 4.99791 6.8918 -3830 4 11.2749 11.5458 15.4981 35.5887 6.11969 38.645 -3831 6 5.69762 16.9728 10.4703 1.06122 -0.586779 5.28994 -3832 4 4.99177 17.1708 11.0979 -1.96678 -11.04 -5.71485 -3833 4 5.85288 17.8179 10.0528 3.40155 4.97172 -3.96907 -3834 6 41.7052 34.1635 35.8846 2.77529 22.9845 38.2917 -3835 4 41.9958 35.0267 36.2582 -8.6238 -19.1969 -5.00662 -3836 4 41.6615 34.3005 34.9574 -2.57818 -0.630621 -34.674 -3837 6 33.7668 1.16041 30.1021 -7.73366 -5.3538 60.0773 -3838 4 32.8437 1.27671 30.3431 -6.56672 10.3256 -18.6068 -3839 4 34.0939 1.04339 31.0463 15.1522 -1.22783 -40.312 -3840 6 50.3589 18.6227 36.9888 29.2523 22.0538 -2.88024 -3841 4 50.1022 18.8636 37.8788 -6.7252 3.81489 7.59342 -3842 4 49.7597 17.9698 36.6907 -30.5426 -29.286 -11.4073 -3843 6 24.6818 24.2557 40.239 -30.3362 18.6852 9.52233 -3844 4 23.7683 24.4347 40.5809 21.1328 -2.57181 -5.50386 -3845 4 24.791 23.3075 40.3447 2.5826 -1.14956 -5.51696 -3846 6 37.3025 22.0306 23.2304 -1.24857 -1.55203 26.5345 -3847 4 37.0034 21.8174 24.1364 -3.77965 7.42086 -11.5868 -3848 4 37.7677 21.2337 22.9852 8.84969 -1.31238 -13.2672 -3849 6 48.4163 40.4951 28.9695 -6.68628 11.813 -16.9736 -3850 4 49.0084 41.2243 28.7075 -10.6266 -4.31108 -6.63999 -3851 4 47.6767 40.479 28.3098 12.2088 -0.876211 11.6705 -3852 6 24.8524 8.74511 16.566 -5.47802 -1.24744 16.6444 -3853 4 25.3154 9.32041 17.1898 2.58295 -0.80606 -7.28092 -3854 4 25.3735 7.93816 16.4942 1.51819 -5.71343 -7.74972 -3855 6 19.2312 23.0154 32.4581 7.29767 -10.2486 -2.08042 -3856 4 18.4295 23.4489 32.1618 3.75321 4.57429 -6.83594 -3857 4 18.9208 22.4103 33.1253 1.01223 -4.21105 8.69504 -3858 6 3.33807 21.6805 22.4551 -46.3933 -7.60477 16.0737 -3859 4 2.65604 22.1286 23.0335 23.3212 -20.9163 -13.0515 -3860 4 4.02869 22.318 22.3903 27.1551 13.0827 -5.07429 -3861 6 10.2258 20.3371 12.829 -8.54969 -20.6717 -8.68144 -3862 4 9.56384 20.8338 13.3253 4.28314 2.73019 -3.94148 -3863 4 9.70568 19.6401 12.367 8.3544 15.6282 9.01344 -3864 6 9.53393 0.668964 25.3385 8.23748 17.1946 -9.08311 -3865 4 10.3992 0.538209 25.8183 -20.1327 16.9559 -17.4439 -3866 4 9.57635 1.38514 24.6117 12.9812 -33.3008 29.4344 -3867 6 10.6624 40.712 9.64369 -16.6479 -8.09828 -30.6343 -3868 4 10.6692 41.3905 10.303 1.51816 10.4523 18.0663 -3869 4 9.97599 41.0031 8.99599 12.0328 -9.66263 16.6565 -3870 6 46.359 25.2248 32.6769 -14.7838 37.2607 37.796 -3871 4 46.1367 26.0735 33.2154 13.6855 -48.6436 -31.9122 -3872 4 46.6282 25.5659 31.8216 4.36769 -3.83668 -6.22015 -3873 6 38.9431 3.2028 23.1016 18.0409 -17.6687 24.963 -3874 4 38.0396 3.32435 22.9005 -28.138 13.963 -19.732 -3875 4 38.8834 2.64883 23.9052 13.1186 5.8311 -6.82495 -3876 6 33.334 23.6417 36.8871 -1.6197 -14.346 14.9842 -3877 4 32.7695 23.6175 37.7211 18.6046 10.6207 -30.6843 -3878 4 33.5528 24.5621 36.6745 -4.59115 1.63353 1.59233 -3879 6 51.9355 33.3272 25.435 24.4931 61.1901 -39.0042 -3880 4 51.4286 33.1494 26.1943 -20.5556 -13.8295 37.3068 -3881 4 51.9313 34.3506 25.3627 -2.33157 -52.0679 -5.38276 -3882 6 32.1777 25.0215 33.1655 -4.40266 21.2191 -9.05445 -3883 4 32.7541 25.8194 33.0841 -10.7751 -17.7804 3.95932 -3884 4 31.2703 25.3891 33.0319 13.5135 -10.8842 0.697404 -3885 6 51.2858 27.7149 39.5023 -29.438 -28.7732 26.1015 -3886 4 51.6029 27.7352 38.6212 16.0201 9.86215 -30.6452 -3887 4 51.6337 28.456 39.976 12.6328 17.4546 7.30145 -3888 6 34.2938 28.319 17.2582 8.1769 -6.30709 4.0332 -3889 4 33.5147 28.7567 16.9609 -27.2201 13.5182 -7.119 -3890 4 34.2215 28.3851 18.2119 5.48963 -10.3892 10.8325 -3891 6 36.9125 8.03614 37.8626 31.6258 41.6511 37.5008 -3892 4 37.1772 8.64874 37.1722 -6.23292 -16.4311 -22.0997 -3893 4 37.3691 8.52088 38.6203 -30.9712 -36.3395 -15.9768 -3894 6 34.8794 19.4073 6.12479 12.5531 6.66298 1.29528 -3895 4 34.0931 18.8687 6.15723 -9.84615 -2.81902 0.903663 -3896 4 34.5874 20.3343 6.07707 7.75337 -1.04832 -3.72421 -3897 6 52.9388 9.46792 7.82791 49.0384 32.8563 -49.3294 -3898 4 52.8922 10.1625 7.06425 -6.6048 -31.3865 41.9454 -3899 4 52.145 9.34409 8.30569 -37.6802 7.72308 13.142 -3900 6 36.3078 5.4787 38.9756 -59.3492 -35.3574 -23.3076 -3901 4 36.7604 5.44249 39.7856 34.2456 7.44664 27.0781 -3902 4 36.4713 6.28646 38.5283 19.3627 32.146 -13.2298 -3903 6 10.0102 14.4476 13.47 7.45507 32.9986 11.9551 -3904 4 10.2267 15.3574 13.7991 -6.33005 -21.0964 -5.42394 -3905 4 9.26267 14.5991 12.8847 -7.70629 -5.78085 -0.713961 -3906 6 17.2158 24.3617 39.7859 1.82925 -26.4802 17.5225 -3907 4 16.9252 25.2477 39.6578 -10.2532 23.1813 -8.78866 -3908 4 16.8659 24.1409 40.6742 12.3143 -2.49802 -8.33055 -3909 6 49.0708 32.5605 7.76617 4.98775 -19.9892 12.4117 -3910 4 48.2488 33.0406 7.85919 -4.66971 4.38963 1.84033 -3911 4 49.5854 32.9586 7.08254 9.03816 10.9607 -18.1455 -3912 6 44.8772 24.3958 5.47001 55.4245 15.4507 -4.26518 -3913 4 44.8128 24.5742 6.41303 -16.1158 -0.171295 7.10823 -3914 4 44.0866 23.9971 5.17679 -42.0653 -18.1716 -4.3799 -3915 6 37.3106 29.1913 32.8596 13.2918 -7.82588 25.4298 -3916 4 36.7195 29.353 33.61 10.148 2.43022 -0.346483 -3917 4 36.7915 29.3572 32.1043 -27.5405 3.64351 -29.7293 -3918 6 0.903259 24.8209 21.2384 21.1637 23.8586 -12.5999 -3919 4 1.07153 25.1845 20.3306 -6.36458 -4.90686 24.2304 -3920 4 1.48599 25.3539 21.839 -15.2813 -16.355 -7.82064 -3921 6 53.0335 2.20305 13.0061 -8.76459 0.917863 -30.1717 -3922 4 52.7178 1.83592 13.8181 -1.16689 -4.66991 20.3458 -3923 4 53.3973 3.07458 13.1779 4.70755 1.41814 13.7418 -3924 6 24.3073 33.9788 13.9425 26.9643 -19.8352 3.53447 -3925 4 23.8166 33.1535 14.1304 2.48225 11.7572 -2.64876 -3926 4 25.2622 33.8278 14.204 -36.1259 9.29052 -3.07765 -3927 6 40.931 19.3008 0.314297 -22.2267 40.7784 4.53314 -3928 4 41.073 18.3876 0.266006 15.5735 -49.6404 -1.39225 -3929 4 41.7685 19.7545 0.415523 11.1161 2.19254 -0.550631 -3930 6 38.3131 32.0321 21.5909 -11.558 27.6654 -12.3629 -3931 4 37.7152 31.3901 21.181 3.54948 -0.803384 -4.61225 -3932 4 38.0485 32.9451 21.2634 6.02672 -33.9485 15.0266 -3933 6 42.3093 34.9988 16.9782 -31.0886 21.3467 -4.04435 -3934 4 41.4322 34.9872 17.4259 23.1708 5.16072 -1.2535 -3935 4 42.7209 34.172 17.1456 10.0707 -23.8474 2.85212 -3936 6 19.5555 24.3301 21.9337 4.81064 -45.312 41.7565 -3937 4 19.0503 23.5208 22.2695 18.6897 32.4519 -16.5084 -3938 4 18.9494 24.7901 21.383 -21.2783 9.24005 -16.3011 -3939 6 21.0765 3.08453 14.9497 18.8565 6.62045 0.482113 -3940 4 21.9827 3.42458 15.1377 -20.4059 -2.71097 -2.70114 -3941 4 21.0593 2.94323 13.9894 -7.00518 -5.35814 1.95693 -3942 6 16.4422 12.1477 28.531 -0.750899 4.00912 3.87665 -3943 4 16.9503 12.6102 29.2147 -1.62139 -0.392447 -5.94721 -3944 4 15.8278 12.7952 28.1633 1.40376 -4.03425 1.22377 -3945 6 29.5501 4.7113 21.752 31.6763 -19.7408 -11.7502 -3946 4 29.7575 3.81476 21.3864 -8.62397 20.1371 9.94028 -3947 4 28.6767 4.97136 21.4837 -14.307 1.15287 -5.34284 -3948 6 47.4015 12.0887 13.4082 -20.234 -20.0739 19.2385 -3949 4 46.7896 12.1748 12.658 5.24956 2.33261 8.08179 -3950 4 46.8763 11.6307 14.143 25.8489 23.9178 -32.3489 -3951 6 26.4368 0.034911 5.58657 -64.7941 -10.5287 17.818 -3952 4 25.4579 0.386547 5.64311 57.7785 -5.53424 -8.5606 -3953 4 26.2825 41.0177 5.90114 11.1228 18.2746 -10.9356 -3954 6 20.8239 34.8091 41.3451 3.02448 22.7042 23.7072 -3955 4 20.8848 35.7307 41.7064 -1.83719 -23.2001 -12.5561 -3956 4 21.5135 34.3024 41.8142 -0.435548 5.34794 -5.15218 -3957 6 12.6914 17.4806 1.38079 -1.22179 11.8948 19.0955 -3958 4 12.6924 17.2614 2.32235 1.20892 0.120609 -3.36771 -3959 4 12.6119 16.652 0.923905 -0.609755 -13.5185 -16.0456 -3960 6 30.0783 10.198 8.41195 2.12134 -1.25171 -25.3141 -3961 4 29.3533 10.7626 8.0964 5.01977 -3.23694 0.534487 -3962 4 29.9182 10.0601 9.33268 -3.94599 -2.47727 24.1034 -3963 6 36.3506 5.44781 23.9083 -0.549638 14.3818 20.7021 -3964 4 36.0156 6.32048 23.6328 6.62881 -2.58855 0.476976 -3965 4 37.0027 5.63115 24.6267 -8.58297 -8.41851 -13.9364 -3966 6 34.0301 39.9488 19.4964 -23.0399 -20.8249 18.5921 -3967 4 34.456 39.4415 20.2152 6.93565 15.6495 -14.2212 -3968 4 34.6348 40.5483 19.0534 11.5364 2.12704 2.14354 -3969 6 25.0981 29.0133 17.0022 63.4673 53.603 -24.6749 -3970 4 24.4066 28.4545 17.2066 -49.3728 -47.1307 14.2315 -3971 4 24.9323 29.3693 16.11 -4.01222 -10.2038 10.3173 -3972 6 28.4991 21.3215 6.5284 30.3134 51.3135 12.4116 -3973 4 28.073 21.8131 5.82363 -12.0684 -17.0718 -17.6117 -3974 4 29.0439 22.0969 6.88435 -18.1485 -38.7813 5.23359 -3975 6 18.6639 26.1486 0.434559 17.278 41.4043 -10.2832 -3976 4 18.2934 25.3073 0.618971 -26.4426 -25.2614 5.85754 -3977 4 18.1648 26.8598 0.892557 2.28699 -17.4047 3.2853 -3978 6 10.9881 29.7025 15.4563 -76.0882 18.6105 19.9394 -3979 4 11.66 29.3744 14.945 58.6215 -25.2203 -34.7363 -3980 4 11.3165 30.0451 16.2682 18.0847 5.23212 20.5617 -3981 6 33.4842 3.75768 10.5858 0.636803 10.5574 28.6939 -3982 4 33.4734 3.50079 11.5612 -0.522502 1.02567 -36.066 -3983 4 33.5593 4.73652 10.6 -0.068286 -14.4363 0.33475 -3984 6 12.2823 28.8038 23.0281 11.3775 -6.29424 6.84391 -3985 4 12.7596 29.6284 22.9364 3.04418 8.52871 -1.54448 -3986 4 11.6562 28.9633 23.7417 -11.9653 1.92572 -6.97409 -3987 6 13.0879 10.2853 41.0171 -47.2786 6.02767 7.69694 -3988 4 13.8008 10.0588 41.5617 38.8858 -12.6991 24.323 -3989 4 13.445 10.533 40.1929 12.5253 9.31307 -31.237 -3990 6 45.8279 29.9763 22.3517 -19.0059 -47.3471 -0.794771 -3991 4 46.3385 30.6632 22.7121 22.9496 35.5749 11.5915 -3992 4 46.1736 29.1608 22.8005 -10.4716 15.4455 -15.9284 -3993 6 41.5587 12.1258 14.79 16.8952 2.46742 -19.497 -3994 4 40.8127 12.0778 15.3866 -8.88903 2.06539 11.4921 -3995 4 41.9001 13.025 14.8368 0.886253 5.83282 4.44761 -3996 6 18.1774 7.21532 24.17 -10.7079 71.0597 15.5191 -3997 4 17.3895 7.85304 24.2309 32.278 -29.8877 -8.26822 -3998 4 17.8432 6.3671 24.0218 -31.5603 -50.1252 -1.23769 -3999 6 1.46617 28.3087 7.5822 17.4051 32.8243 -18.4272 -4000 4 0.972435 27.5241 7.77639 -23.983 -7.56132 -3.64975 -4001 4 0.919057 29.0368 7.16413 8.17263 -22.6878 11.3207 -4002 6 11.3257 12.3178 24.0505 6.50608 36.5044 21.7543 -4003 4 11.787 12.9182 24.6663 -15.142 9.53056 -9.69028 -4004 4 11.7144 11.5384 24.3755 9.90684 -45.3393 2.97811 -4005 6 17.9727 40.4585 24.4268 -2.1753 13.4943 43.6914 -4006 4 18.2079 40.9973 23.706 15.3173 17.1897 -35.5256 -4007 4 17.8423 41.1404 25.131 2.16294 -27.9915 -10.5346 -4008 6 25.5983 7.44259 34.0136 19.3716 5.77393 -21.6373 -4009 4 25.8935 7.97324 33.2232 -7.88236 -13.8451 20.6491 -4010 4 24.6626 7.5793 34.1612 -12.3217 5.75259 0.6842 -4011 6 16.9533 36.3934 7.79695 -14.7733 -58.972 -15.2131 -4012 4 16.1509 35.7821 7.92089 32.5681 38.8119 0.0631702 -4013 4 16.873 37.2333 8.21975 -10.866 19.0251 14.3825 -4014 6 12.4478 39.1676 36.8063 -58.2746 -19.2691 -7.14825 -4015 4 13.2621 39.5728 37.0444 24.763 -2.90148 -1.94315 -4016 4 12.5678 38.2718 36.42 14.2903 21.5885 11.3364 -4017 6 23.4428 1.91286 37.7232 -9.22102 6.32267 -24.8838 -4018 4 22.7837 1.60923 37.0782 3.11058 2.78987 13.6287 -4019 4 23.6923 2.7833 37.361 6.97145 -2.92816 9.87668 -4020 6 26.6131 34.8527 39.0629 -0.358317 22.46 -5.08852 -4021 4 25.9211 35.0251 39.7209 4.63868 -0.642547 -8.45736 -4022 4 26.6245 35.623 38.4346 -11.8568 -25.3624 13.8384 -4023 6 44.7506 35.5772 23.1679 10.7298 -18.8811 -26.4233 -4024 4 44.6498 36.2622 23.8111 -7.39072 22.4611 10.5052 -4025 4 44.899 35.9413 22.2637 -2.27133 -5.1907 16.9936 -4026 6 34.6136 35.4178 26.71 -15.9342 1.46423 13.2724 -4027 4 33.7739 35.201 27.1682 15.3038 9.13482 -13.5788 -4028 4 35.2424 35.4667 27.4557 -1.55634 5.60609 -12.3698 -4029 6 12.4253 29.8367 9.37257 6.8074 7.71813 14.8361 -4030 4 12.5954 30.1793 10.279 -1.64518 -2.79843 -17.3301 -4031 4 11.9756 30.5342 8.87466 -2.55144 0.413422 5.70549 -4032 6 46.4578 41.3781 16.9525 -1.71223 -15.9012 -6.63524 -4033 4 46.309 0.164546 17.5847 2.66821 13.6546 8.2853 -4034 4 46.3887 41.8168 16.0911 -0.805017 -2.71613 2.08401 -4035 6 39.1753 31.0467 24.0118 -3.10819 6.08124 -21.6124 -4036 4 39.1065 31.2708 23.0301 -7.23524 -5.82233 36.9271 -4037 4 38.2867 31.0608 24.4123 9.52041 3.88051 -10.8568 -4038 6 40.5402 9.7597 28.9847 14.8037 -28.2595 -25.194 -4039 4 40.7176 8.78836 28.9335 -4.00485 22.4893 3.39032 -4040 4 39.9733 9.89103 29.7293 -9.65138 5.58475 19.0645 -4041 6 33.5593 11.9211 22.729 -1.15717 -3.69298 36.7387 -4042 4 33.4631 12.1387 21.8005 -14.8881 8.7456 -3.74916 -4043 4 32.9393 12.4796 23.2922 26.8098 -15.4098 -27.756 -4044 6 29.0159 38.7519 2.46278 27.6721 -15.5988 -40.3681 -4045 4 29.1586 39.6546 2.1748 2.74048 3.67355 2.54153 -4046 4 28.5501 38.8453 3.26351 -22.211 -0.421087 25.3577 -4047 6 51.2833 6.14739 28.3043 6.24107 -1.78447 -16.8419 -4048 4 51.6927 5.30788 28.0231 -4.79213 3.01935 13.8596 -4049 4 51.5671 6.73798 27.5888 -1.89698 -2.53529 10.4249 -4050 6 34.1064 16.6123 14.042 -37.0155 -16.4066 -7.07731 -4051 4 33.9904 17.5439 13.9588 -10.6946 23.5239 -0.125603 -4052 4 35.0244 16.4872 14.0391 48.662 -2.86898 -0.118382 -4053 6 34.4321 40.0645 7.48859 13.9518 5.57425 38.6209 -4054 4 34.6497 40.8416 6.93548 -15.3832 -25.9537 -5.407 -4055 4 34.0868 39.3056 7.01264 2.49953 7.17747 -18.8692 -4056 6 42.5297 22.9808 4.38266 2.56422 12.7755 -29.8183 -4057 4 42.7079 23.1404 3.43503 2.07895 -8.20356 9.72626 -4058 4 41.6007 23.2438 4.43282 3.68115 -1.88729 13.9368 -4059 6 1.41725 11.7089 10.583 40.9585 72.4956 7.82458 -4060 4 2.29602 11.7947 10.1149 -31.3121 -19.1762 2.07637 -4061 4 1.32217 12.6809 10.8959 0.250133 -47.8987 -12.0904 -4062 6 10.0222 17.1523 40.4009 -13.9984 -42.4532 23.0969 -4063 4 9.09922 16.7881 40.4362 25.3227 17.9847 -3.64852 -4064 4 10.5566 16.4623 40.9043 -11.7978 28.1532 -20.1855 -4065 6 26.3773 1.16785 23.7951 0.897687 17.1036 -20.4546 -4066 4 26.2949 1.59753 22.8926 6.72339 -10.2637 31.134 -4067 4 26.8106 1.83522 24.3632 0.404944 -5.36666 -8.232 -4068 6 4.47728 16.2319 39.0174 38.9165 -19.7518 -18.3291 -4069 4 4.60126 15.8787 38.0926 -3.95383 11.2541 23.7603 -4070 4 5.37849 16.1152 39.4714 -36.6531 9.54225 -13.0705 -4071 6 24.3645 39.8454 14.0862 11.6717 18.512 -7.42816 -4072 4 24.2179 40.7168 13.6655 -1.51261 -13.0973 5.973 -4073 4 25.144 39.5095 13.6466 2.38152 -7.3908 -1.6645 -4074 6 19.9724 19.004 10.1294 8.87966 -14.5095 2.71373 -4075 4 19.0999 19.3915 10.2782 -1.93643 -3.06257 7.63815 -4076 4 20.1403 18.2899 10.8137 -9.49435 28.7308 -18.8504 -4077 6 45.2455 15.0555 25.2985 9.44949 25.5865 29.6023 -4078 4 44.5225 15.6147 25.6238 -9.11717 -2.3226 -13.4673 -4079 4 44.9162 14.4027 24.6993 -17.0358 -18.2103 -14.0354 -4080 6 47.6513 32.9537 29.9733 -3.02769 -8.48031 15.1317 -4081 4 47.7848 32.4488 30.7976 5.01558 10.2706 -8.76515 -4082 4 46.6987 33.0693 29.9097 -5.02316 -0.316015 -4.02449 -4083 6 9.31033 14.1561 35.6305 -9.15199 13.4931 14.7277 -4084 4 10.2186 13.9515 35.3646 1.69372 -1.68405 10.862 -4085 4 9.25805 14.5533 36.5394 11.2175 -11.577 -22.5615 -4086 6 0.560208 28.7354 32.128 -23.2584 38.0618 20.8665 -4087 4 0.439761 29.1616 31.2639 2.79308 -8.58991 0.800302 -4088 4 0.67028 27.8063 31.9961 10.5465 -16.7679 -9.91325 -4089 6 26.1282 14.1993 40.8411 59.6454 -38.6249 5.43898 -4090 4 26.432 13.4524 41.4491 -20.3805 31.5142 -12.0858 -4091 4 25.201 14.2926 40.8644 -35.6636 2.31432 7.08225 -4092 6 38.0409 1.72795 37.3461 -15.986 9.3487 3.27435 -4093 4 38.337 1.77003 36.4219 -6.4212 0.733726 8.60438 -4094 4 37.1869 2.24333 37.3721 25.3175 -16.9011 -0.126137 -4095 6 43.391 21.0055 0.385428 11.1435 51.3868 10.1231 -4096 4 43.3728 21.9356 0.739051 -22.7765 -27.5137 5.23027 -4097 4 44.2566 21.1078 41.893 4.66373 -25.0138 -11.6612 -4098 6 29.7339 12.3948 17.084 15.7249 11.0657 13.1734 -4099 4 30.3928 12.9555 17.5239 -4.04604 16.1495 -27.1654 -4100 4 29.6387 11.801 17.8166 -19.321 -23.8097 4.84602 -4101 6 21.0831 10.9976 35.6454 20.8751 25.9078 26.8503 -4102 4 20.9144 11.9356 35.5 -2.5465 -0.914036 2.40284 -4103 4 20.6111 10.5739 34.9651 -17.7649 -25.2648 -31.6786 -4104 6 24.3635 22.1336 17.0651 -49.7832 5.03398 -16.9936 -4105 4 24.7447 22.8357 16.5516 14.0354 11.6369 -2.31656 -4106 4 25.0369 21.6158 17.4366 35.7007 -17.2122 18.4164 -4107 6 44.2543 9.63808 6.15039 20.313 -11.2139 14.5913 -4108 4 44.7688 9.46356 5.36091 -1.47318 -0.699349 -10.0319 -4109 4 43.371 9.9028 5.92157 -14.9065 6.10764 -5.2575 -4110 6 40.8032 2.87739 6.28666 -13.1289 22.479 10.901 -4111 4 40.3272 3.11809 7.09229 2.74106 -9.45257 -1.64817 -4112 4 40.5645 3.60702 5.69531 8.12536 -6.41414 -12.3146 -4113 6 23.4888 29.7691 25.1996 -20.8577 -7.3866 7.78845 -4114 4 23.0356 30.0691 24.4173 -11.1707 -5.96106 -7.76576 -4115 4 24.1981 30.3761 25.2406 38.2449 14.7306 0.541559 -4116 6 45.2336 20.6129 7.48752 -14.5833 -17.9538 -3.88696 -4117 4 44.4222 20.5961 6.94177 10.1673 3.83834 -0.615812 -4118 4 45.4226 19.6724 7.65027 4.1577 11.2609 0.378107 -4119 6 44.1804 26.5848 16.646 -7.77871 8.0927 60.0057 -4120 4 44.4497 26.5291 15.7549 9.82788 -17.3929 -39.3829 -4121 4 43.995 25.6977 17.0036 0.668911 -2.30329 -14.751 -4122 6 23.5902 27.0659 18.0913 -39.7013 -11.93 7.95298 -4123 4 23.083 26.2674 17.8176 19.208 11.4009 -9.44785 -4124 4 22.9184 27.4761 18.6801 25.6051 0.00742342 -8.40738 -4125 6 45.1467 16.0991 8.91755 -25.3782 -1.90264 -8.59791 -4126 4 44.1891 15.9425 8.7462 16.1978 6.4454 1.17339 -4127 4 45.2138 16.0078 9.87006 7.52298 -2.6657 10.2407 -4128 6 39.0203 15.1531 5.23259 28.6956 12.0263 -26.8074 -4129 4 39.7994 15.5772 4.7964 -10.087 -12.1112 6.39319 -4130 4 38.3368 15.7917 5.08662 -19.5574 10.6606 0.980846 -4131 6 40.468 4.77411 20.0927 -27.3359 -4.798 12.1592 -4132 4 41.2634 4.72652 19.6 29.6653 -1.38796 -18.2664 -4133 4 40.7147 5.23292 20.8909 -0.487482 4.30709 11.6637 -4134 6 35.8395 28.4372 39.9091 -50.8572 -25.335 -8.14583 -4135 4 35.0416 27.8127 39.7761 37.8149 25.8469 12.2999 -4136 4 36.4241 28.1912 39.1903 12.774 -11.5781 0.139918 -4137 6 26.5706 3.57143 2.67715 -46.9093 11.529 -12.2012 -4138 4 26.01 3.47498 1.86726 21.0232 -0.263485 19.1529 -4139 4 25.9795 4.13239 3.25499 25.5536 -16.3527 -3.3314 -4140 6 2.96374 21.6426 17.6806 -14.2306 -5.51577 -4.68338 -4141 4 2.93927 22.2072 18.4518 0.989431 6.72084 9.51867 -4142 4 3.70489 21.9005 17.1296 5.59779 10.8847 0.849605 -4143 6 12.8869 25.0552 25.9401 15.4127 26.4598 -14.83 -4144 4 13.2774 25.9118 25.6194 -5.06291 -21.1213 8.866 -4145 4 12.0842 24.9634 25.4247 -11.7493 -3.09829 -2.0396 -4146 6 41.5869 20.6707 14.1801 -22.4147 -6.05744 0.611169 -4147 4 42.2929 20.1295 13.8255 12.8925 2.43785 -7.39699 -4148 4 41.9118 21.5622 14.3536 8.70683 -8.7017 2.36606 -4149 6 1.26372 39.5934 11.5416 -2.31472 -23.2994 -17.666 -4150 4 1.60499 38.7626 11.0579 -12.721 36.8399 30.164 -4151 4 1.30151 39.4907 12.5143 8.15813 -4.07121 -11.1907 -4152 6 16.0274 39.0089 34.0759 -23.376 3.35378 -54.2756 -4153 4 15.5279 38.2654 33.6809 12.2329 5.59336 21.1278 -4154 4 15.9645 39.6681 33.3256 8.94624 -4.65522 31.8649 -4155 6 20.5749 7.01511 25.5545 -9.93748 22.9073 -1.77669 -4156 4 20.7998 7.9126 25.2373 7.69672 -13.5438 0.480138 -4157 4 19.6147 7.02086 25.4453 1.79337 -5.45304 -5.32881 -4158 6 45.1903 25.5946 39.1745 -26.3826 2.10768 23.1727 -4159 4 45.9078 26.0337 38.7511 23.0136 15.7961 -19.2282 -4160 4 45.315 24.6755 38.9972 4.74877 -22.0383 -3.82349 -4161 6 19.9254 40.1108 28.2935 0.936604 13.13 -6.83142 -4162 4 19.0415 40.3022 27.9603 -1.00367 -13.9734 -0.221352 -4163 4 20.1058 40.9072 28.8104 6.81084 -8.28794 7.10232 -4164 6 26.5025 14.2024 27.3816 7.55525 -11.5245 -39.7478 -4165 4 25.5661 14.1885 27.2241 -23.3405 -0.187867 -1.3667 -4166 4 26.5864 14.6167 28.2174 4.05242 7.69107 36.9512 -4167 6 51.349 25.9455 3.44193 13.1564 1.83251 -14.1309 -4168 4 51.0731 25.276 4.04973 -8.84751 -13.2679 15.0063 -4169 4 51.8098 25.4164 2.75525 -2.9574 19.5765 2.79729 -4170 6 20.1579 26.1269 2.66057 8.08543 -14.232 12.5138 -4171 4 20.4198 25.2285 2.95049 1.99012 13.1431 -7.88687 -4172 4 19.9848 26.1042 1.70984 -1.68704 0.137755 2.48294 -4173 6 3.12857 11.9594 27.2244 18.8731 20.7243 14.7894 -4174 4 2.60719 12.6622 26.8077 5.30838 -2.59233 -3.81502 -4175 4 3.76928 12.4285 27.8301 -19.9135 -11.7573 -12.7739 -4176 6 30.1745 26.3671 4.00755 44.117 -33.7612 35.926 -4177 4 30.7719 25.91 3.40695 8.20711 -11.5121 5.52432 -4178 4 29.6741 26.8182 3.4039 -49.0538 48.0497 -39.0484 -4179 6 19.309 20.6617 30.5327 -6.17305 20.3286 19.7257 -4180 4 19.3357 21.5037 31.0044 -16.2324 -1.53368 2.5841 -4181 4 20.215 20.6027 30.2783 24.1248 -10.9268 -16.9107 -4182 6 13.5428 36.2605 0.333332 15.0011 -10.6689 28.2547 -4183 4 13.9636 37.1467 0.274336 -13.564 -9.3403 -16.0521 -4184 4 12.8146 36.0991 41.6409 -4.77188 14.7057 -15.3617 -4185 6 13.69 21.7667 35.9665 -20.2473 -15.4187 -13.4538 -4186 4 13.4364 21.3658 35.099 7.7487 10.4825 13.8843 -4187 4 14.5406 22.1631 35.8296 17.4857 6.37333 -3.13554 -4188 6 39.4374 1.76506 25.3393 -36.4427 -7.29022 -10.5984 -4189 4 39.9364 2.34528 25.9215 16.7605 -3.08023 1.72977 -4190 4 39.8192 0.8892 25.1573 19.013 15.1682 11.727 -4191 6 18.3049 6.14326 35.8392 -10.8025 -19.5812 3.54688 -4192 4 18.125 5.32611 36.3393 4.50778 0.182671 -16.8727 -4193 4 18.2664 6.78418 36.55 10.3297 13.4079 -7.40032 -4194 6 2.50698 24.635 10.1008 2.82606 57.1639 14.1456 -4195 4 3.34783 24.2504 10.0645 38.9609 -42.7111 -6.9151 -4196 4 2.85647 25.509 10.4424 -34.1939 -15.4438 -5.60802 -4197 6 35.8245 9.94707 1.36321 12.392 22.5458 6.51215 -4198 4 36.2598 10.3662 0.602857 -1.03193 -1.33218 7.37913 -4199 4 36.14 10.4815 2.15194 -8.91958 -29.9524 -28.0328 -4200 6 29.0093 17.9332 41.5934 -7.9582 -11.0366 0.585828 -4201 4 28.5465 17.2289 41.1281 -16.7755 -3.81322 9.83818 -4202 4 29.6221 18.1453 40.9114 24.9254 25.1746 -10.164 -4203 6 46.0106 27.0842 25.8657 -15.8538 -10.6571 1.20957 -4204 4 46.7573 26.8966 26.4316 13.3887 1.52966 8.34957 -4205 4 45.3967 26.3449 26.0537 1.02353 6.85943 -7.5889 -4206 6 28.1115 10.6516 35.9124 -31.4415 -9.81676 -35.067 -4207 4 27.3321 11.0804 35.4953 10.9044 -14.8673 0.927998 -4208 4 28.4149 11.3158 36.4913 19.5717 24.3857 28.0975 -4209 6 25.9462 20.1874 24.7713 21.0981 19.7274 8.06252 -4210 4 26.7479 20.7296 24.6265 -12.3387 -9.71047 -3.27099 -4211 4 25.8934 20.1715 25.7373 -11.4252 -1.9185 3.65337 -4212 6 32.2315 30.2636 10.2038 46.2181 -42.2335 3.06511 -4213 4 32.6954 30.7903 9.55855 -13.4496 21.2522 -10.6663 -4214 4 32.9512 29.5744 10.3289 -28.7668 14.232 9.31608 -4215 6 5.05112 34.4033 23.8133 19.5013 -14.7597 17.0713 -4216 4 5.8904 34.9145 23.8209 -18.4686 -4.57798 -7.44977 -4217 4 4.4328 34.8283 23.2333 -4.78059 12.4432 -11.9709 -4218 6 29.6287 34.9421 23.1129 15.2461 20.4143 1.29823 -4219 4 30.2662 35.203 23.7945 -9.70178 1.77141 2.28452 -4220 4 29.7307 34.0083 23.0447 -4.13429 -24.1479 2.03513 -4221 6 52.1909 25.2296 36.2512 2.86438 -10.6824 22.6831 -4222 4 51.9483 25.3775 37.2028 5.23419 -4.07811 -26.4725 -4223 4 52.3343 24.2634 36.1804 -4.32722 6.81431 1.64545 -4224 6 6.96184 41.26 14.9825 2.80521 -5.8094 -40.534 -4225 4 7.04984 41.0874 15.8994 5.94782 -9.0625 22.8431 -4226 4 7.58542 40.6644 14.4953 -8.6815 16.2518 18.3581 -4227 6 27.6618 39.1341 4.65497 -15.321 -2.42325 19.5764 -4228 4 26.8583 38.6531 4.9607 13.8024 7.31782 -7.34321 -4229 4 28.2878 39.16 5.39008 -5.06496 -7.53921 2.22048 -4230 6 44.4448 15.8874 30.3939 -2.31018 0.103575 -22.4191 -4231 4 43.6353 16.4379 30.2788 15.6665 -12.4266 1.42045 -4232 4 44.7559 15.574 29.5018 -16.8402 11.4423 19.721 -4233 6 27.2939 38.1254 13.0955 15.3768 -40.6351 2.35664 -4234 4 27.6299 37.3572 12.5713 -6.06373 15.2601 5.99839 -4235 4 27.2975 37.7701 14.0147 -10.0522 11.5876 -10.9657 -4236 6 26.6773 32.9794 36.8294 -32.6396 -25.4624 12.1292 -4237 4 27.3491 33.5429 36.5103 30.2383 22.5556 -9.12925 -4238 4 26.1784 33.4868 37.4729 2.39424 7.35453 7.52648 -4239 6 26.3034 28.2003 31.7109 71.1077 16.3155 0.283388 -4240 4 26.8193 28.3341 30.863 -27.929 -6.55919 23.3278 -4241 4 26.9955 28.4613 32.4053 -35.143 -9.24619 -18.2719 -4242 6 49.2075 35.7729 23.3324 -21.4287 30.6035 9.89313 -4243 4 49.7648 36.3085 23.9054 5.92838 -6.84736 -0.0129328 -4244 4 49.7125 35.0813 22.9401 23.5965 -22.3057 -11.2126 -4245 6 44.2384 15.3735 33.5479 -0.546939 -12.4927 -0.897907 -4246 4 44.8734 15.133 32.8785 13.8917 -2.34347 -2.72297 -4247 4 43.5631 15.8174 33.0372 -7.79828 14.1806 -0.143619 -4248 6 16.6415 35.2629 14.0425 -13.711 -12.7272 -22.5016 -4249 4 16.8779 36.1297 14.3524 2.35153 17.3801 14.4176 -4250 4 15.7232 35.3535 13.695 18.4875 1.24889 7.88518 -4251 6 45.2979 21.4768 12.0753 -61.6802 -17.7786 9.36854 -4252 4 45.9745 21.1118 11.5746 47.2025 -15.5682 -31.9287 -4253 4 44.6407 20.7302 12.0307 13.4445 30.1014 15.4365 -4254 6 51.647 5.33893 20.0992 17.3373 6.85256 40.4731 -4255 4 51.8423 5.82757 20.9547 -12.0569 -16.4938 -26.4666 -4256 4 50.8652 5.75336 19.736 -8.70547 10.2387 -6.49138 -4257 6 22.616 27.3068 0.953729 -12.5585 5.72419 11.7926 -4258 4 21.9912 27.9206 1.39427 2.62886 -13.0847 -9.82719 -4259 4 22.9744 27.8285 0.229956 6.91293 3.08187 -2.36887 -4260 6 46.8924 12.1405 22.3241 28.0037 10.4006 6.07885 -4261 4 46.5361 12.6234 21.5839 -13.5229 3.11861 -11.9828 -4262 4 46.2058 11.655 22.757 -25.8682 -9.85748 8.02404 -4263 6 33.7577 5.61095 25.2306 8.81298 -10.6825 9.18366 -4264 4 34.4045 5.06092 24.7535 -5.77276 6.31779 -0.0821136 -4265 4 33.06 5.8369 24.6155 -4.37455 2.20678 -7.03208 -4266 6 44.2424 18.1337 27.2287 35.5912 4.17402 -1.61274 -4267 4 44.1428 18.6708 26.4104 -1.15401 -3.8952 20.8354 -4268 4 45.2041 18.2132 27.495 -32.4507 -0.562547 -10.2772 -4269 6 5.27745 36.9951 29.0779 -48.9341 45.2857 -18.2185 -4270 4 4.83797 37.847 28.7 19.7525 -41.2711 21.6555 -4271 4 6.18662 37.2124 29.1987 31.023 4.60304 7.81739 -4272 6 20.0415 5.02171 38.9415 13.5567 -45.1901 -20.6947 -4273 4 19.673 5.46942 39.6755 -5.65499 20.9205 26.8401 -4274 4 20.3443 4.13258 39.2728 -11.021 23.424 -4.53385 -4275 6 17.9077 2.77821 33.872 -28.7289 7.66476 22.1934 -4276 4 18.5675 3.36618 33.4993 11.2764 5.36232 -3.32863 -4277 4 17.289 3.30252 34.4687 25.3234 -20.0176 -17.8345 -4278 6 5.56252 23.3664 22.3199 23.4646 34.0494 22.6536 -4279 4 6.31266 23.4141 21.6995 -10.6272 -11.1368 -5.13028 -4280 4 5.83055 24.0852 22.9498 -18.4748 -15.0058 -11.9197 -4281 6 12.7366 28.0136 40.0786 16.9267 17.0007 -14.1953 -4282 4 12.7736 28.981 40.2539 2.04889 -13.1204 -10.7842 -4283 4 13.1752 27.8683 39.2015 -12.0592 5.90979 20.7524 -4284 6 50.5208 38.8121 28.4283 -2.96204 -29.3557 2.62021 -4285 4 51.1161 39.4306 28.008 -0.383593 20.3423 -2.32338 -4286 4 49.7133 39.2143 28.7877 7.69194 10.1621 -6.76025 -4287 6 33.551 8.21903 17.8634 -36.1599 -47.4859 45.2019 -4288 4 33.9333 8.85376 17.3385 32.2471 57.3944 -47.1321 -4289 4 33.8604 7.38657 17.5128 5.83122 -9.97324 -0.737685 -4290 6 34.648 34.7105 17.7828 9.01761 -19.7832 -8.77749 -4291 4 35.1788 35.3328 18.2888 -3.00831 8.66808 4.62333 -4292 4 35.2883 34.0014 17.5711 -12.5093 2.94991 -0.39307 -4293 6 40.7261 5.27864 23.3991 8.21105 0.19251 11.4926 -4294 4 41.4259 4.93717 23.9966 -11.2767 2.88733 -17.4667 -4295 4 40.0598 4.58084 23.2941 1.87831 5.06613 5.43463 -4296 6 16.9137 27.769 14.4809 73.6258 -34.7175 -8.82476 -4297 4 16.0667 28.1115 14.4612 -62.8462 32.6704 -2.60496 -4298 4 17.5486 28.5101 14.4313 -15.9271 -1.25076 7.8547 -4299 6 29.0219 14.6595 5.00786 20.8741 -13.5443 13.1138 -4300 4 29.536 13.8229 4.89138 -12.0375 16.0826 3.98067 -4301 4 28.8859 14.7576 5.97494 -2.91261 0.0620574 -16.4413 -4302 6 36.854 17.7325 5.08016 4.48522 -18.3735 -43.8449 -4303 4 36.2168 18.3553 5.39001 -11.7806 18.6728 17.0618 -4304 4 36.8305 17.8608 4.09391 11.7548 -5.76061 25.8999 -4305 6 27.7142 25.5094 34.8662 20.7401 -29.3529 -12.6468 -4306 4 28.3997 25.1535 35.4786 -13.7878 13.2187 -9.69645 -4307 4 27.3728 26.292 35.2699 -5.77421 14.8272 18.3022 -4308 6 24.7481 17.2805 18.0642 -3.31447 -10.4308 -2.46491 -4309 4 25.3087 17.9154 18.5049 2.27957 10.048 8.00722 -4310 4 24.0564 17.0505 18.7104 4.01172 4.3516 -6.8818 -4311 6 30.1789 1.58441 5.83411 4.12275 19.8646 -71.4749 -4312 4 29.4821 1.85802 6.42075 -6.9839 1.28517 8.89789 -4313 4 29.959 2.0434 4.91278 6.77151 -29.6581 61.3265 -4314 6 37.452 25.891 8.43789 -40.1641 -31.4732 50.6902 -4315 4 38.334 25.9927 8.78667 20.6785 -4.95116 -4.15592 -4316 4 36.9881 25.2791 9.14634 19.6253 32.8331 -49.0064 -4317 6 24.7604 7.00734 2.27008 32.0581 9.85747 -12.4546 -4318 4 25.4028 6.31463 2.48931 -5.40489 7.62931 7.6933 -4319 4 23.9158 6.58667 2.26874 -21.5893 -3.78057 4.11792 -4320 6 25.7887 38.8506 10.7619 -30.5475 28.1992 -59.3139 -4321 4 26.3103 38.4194 11.381 38.5207 -12.4255 48.7922 -4322 4 26.1525 39.7259 10.4932 -1.18865 -9.03037 15.3914 -4323 6 0.555207 13.578 28.1388 12.6332 42.7054 11.738 -4324 4 0.341766 12.7807 27.7179 -10.1825 -36.9478 -16.4943 -4325 4 0.413626 13.4435 29.0864 -5.17296 -1.28815 -2.85065 -4326 6 20.4105 17.1191 12.037 -17.9302 -38.4569 -26.5492 -4327 4 20.2295 17.2547 12.9605 -1.34068 5.07474 20.9983 -4328 4 19.8884 16.3005 11.7926 16.4515 20.0565 4.33162 -4329 6 30.9925 7.37797 16.6653 29.7996 22.3073 3.61878 -4330 4 31.2643 7.03844 15.7784 -2.63758 10.9944 17.123 -4331 4 31.7569 7.94595 17.0261 -27.6116 -29.8279 -14.8225 -4332 6 10.2093 5.78517 12.1714 32.5037 6.96704 58.397 -4333 4 10.1014 6.35617 11.4591 -8.08786 32.1119 -50.7901 -4334 4 9.65707 5.06197 12.024 -36.7963 -41.1043 -15.4671 -4335 6 18.4347 31.3493 24.155 3.48135 -6.25246 2.65688 -4336 4 18.4439 30.3878 24.2879 -2.95335 1.71216 0.944019 -4337 4 18.3198 31.7316 25.0273 -3.67252 2.09543 1.27238 -4338 6 27.8948 29.2525 29.2666 2.33504 21.8021 -21.5937 -4339 4 28.3627 29.5914 28.4251 -11.9103 -18.4763 37.4515 -4340 4 28.5196 28.9609 29.9463 14.9294 0.890267 -8.6061 -4341 6 38.3738 15.4456 29.791 12.9945 -28.6313 15.0543 -4342 4 38.0891 14.5036 30.0544 22.1369 39.5396 -7.74746 -4343 4 39.2957 15.632 30.1541 -37.4531 -3.97597 -10.3113 -4344 6 21.7041 34.7992 5.56934 -10.1436 -56.1371 25.2208 -4345 4 21.4621 33.8673 5.89439 16.7439 32.0975 -19.9868 -4346 4 20.9431 35.2741 5.907 -2.46203 13.3807 -4.97838 -4347 6 18.2064 16.8274 1.01093 1.02147 5.09087 9.91972 -4348 4 17.6405 17.264 0.353478 -0.489627 -6.58546 6.49815 -4349 4 17.8529 17.0628 1.89865 0.517006 0.361128 -13.8735 -4350 6 43.5166 18.4972 39.3436 16.5286 13.9247 -42.0759 -4351 4 43.0101 19.1966 39.7112 -21.9319 15.1254 24.622 -4352 4 43.7095 18.933 38.4597 1.00685 -29.3013 20.2287 -4353 6 17.7976 10.0688 35.5434 7.86102 19.599 -20.2005 -4354 4 17.8945 9.40709 36.2105 4.74187 -18.2058 11.3424 -4355 4 18.5459 9.97323 34.9151 -16.2901 -5.18221 9.2364 -4356 6 36.5889 30.5599 29.0828 -33.0481 48.6405 -12.465 -4357 4 36.5132 31.4977 28.7143 1.54088 -37.0728 8.50934 -4358 4 37.4982 30.324 28.9756 25.7485 -11.7594 -3.68806 -4359 6 38.4943 35.9682 10.4222 10.3079 16.2999 40.226 -4360 4 38.6552 36.6966 11.1228 -3.33458 -34.9071 -25.8136 -4361 4 38.3509 35.1294 10.9235 4.16648 17.1849 -3.98913 -4362 6 43.4036 18.8037 34.3607 -18.7725 -42.8138 41.3108 -4363 4 42.9709 18.1893 33.7432 11.3097 10.906 -2.86187 -4364 4 43.2777 18.3171 35.2411 6.94038 29.5352 -30.5758 -4365 6 11.0585 40.2128 6.10885 -15.7783 5.94868 1.16987 -4366 4 11.5965 40.9262 6.45194 10.3679 4.26541 4.32644 -4367 4 10.1443 40.5526 6.13585 6.40705 -5.05479 -5.29954 -4368 6 48.3342 13.7493 24.4707 -3.46168 30.4962 28.8754 -4369 4 47.8576 13.3588 23.754 -13.8134 -6.92474 -20.9085 -4370 4 47.8711 14.5963 24.7134 14.7345 -25.1065 -10.1999 -4371 6 1.47205 25.7712 23.7829 0.184952 23.7651 -2.41746 -4372 4 0.854396 26.4618 23.4919 -3.79407 -11.1699 -2.17794 -4373 4 2.13056 26.3319 24.2122 9.67536 -12.9921 7.11562 -4374 6 20.5856 0.045789 21.1048 4.96875 -22.7073 -7.43464 -4375 4 19.8117 0.249922 21.5931 -19.4423 21.7426 16.1957 -4376 4 20.4519 41.001 21.0443 13.8042 -0.350206 -3.82588 -4377 6 37.6675 12.896 30.7055 18.9575 -14.1068 -43.1025 -4378 4 37.1872 12.5493 29.907 3.14127 2.53034 24.3729 -4379 4 37.0391 13.1763 31.3358 -31.377 6.23238 20.3235 -4380 6 49.4665 17.3801 9.24655 -8.32961 25.946 -15.5009 -4381 4 48.5345 17.665 9.32633 16.3924 -11.5392 1.15372 -4382 4 49.8219 17.9883 8.54454 -1.98957 -21.6031 19.5257 -4383 6 34.3643 5.3502 17.1421 32.952 7.78829 -18.2658 -4384 4 34.6245 5.26975 16.1857 -14.4704 2.64329 20.4158 -4385 4 33.4298 5.20109 17.2262 -20.6176 -11.2241 -0.901893 -4386 6 14.7832 27.6655 0.085624 -10.3553 13.8949 -22.792 -4387 4 14.1034 27.8892 41.3249 2.03342 -11.2849 14.5146 -4388 4 15.1757 28.5319 0.287496 2.39463 -6.00136 9.68974 -4389 6 48.8635 15.5211 20.7504 -7.30397 3.37214 15.1279 -4390 4 49.1252 16.3754 20.4371 0.183023 13.7927 -3.76167 -4391 4 49.1585 14.9241 20.0762 3.93917 -17.6947 -14.7742 -4392 6 23.8074 40.3851 20.3877 -2.3041 21.5375 32.1864 -4393 4 23.5266 40.991 21.1382 8.45078 -18.9812 -28.3519 -4394 4 24.6929 40.0818 20.645 -4.8729 5.63426 -4.96266 -4395 6 35.18 31.4993 13.7142 -38.6695 32.0432 -41.3249 -4396 4 34.2219 31.3119 13.4889 30.0091 9.93153 3.95626 -4397 4 35.4367 30.7845 14.243 12.3636 -35.8089 30.5679 -4398 6 10.9775 9.01115 39.5206 -26.3812 35.8658 -19.2594 -4399 4 10.5557 9.91556 39.5205 15.5031 -28.3669 -8.85108 -4400 4 11.1542 8.87096 40.4393 5.31517 -3.54045 10.232 -4401 6 53.2061 4.88103 16.6049 -20.6689 -12.7794 3.6937 -4402 4 53.6782 5.3887 17.2239 33.7717 25.1716 19.5104 -4403 4 52.5676 4.51498 17.2255 -11.3933 -13.1169 -19.2452 -4404 6 7.83562 33.8039 26.1496 42.0062 50.3869 -17.047 -4405 4 7.62463 34.1533 27.0155 -6.33847 -9.39794 9.82588 -4406 4 8.42034 34.5749 25.7852 -30.6961 -50.8642 6.91563 -4407 6 31.3279 27.9472 6.28298 4.37835 -19.3247 -9.6219 -4408 4 31.922 27.5111 6.93657 -10.4846 5.09347 -11.9486 -4409 4 31.1129 27.3323 5.53276 6.79934 9.76999 15.6259 -4410 6 31.3655 2.17383 41.055 18.9421 -1.98994 34.5993 -4411 4 31.8109 2.17902 0.04034 -17.0754 7.04602 -28.7946 -4412 4 31.2404 1.23747 40.9086 -7.00813 -7.80206 -8.22245 -4413 6 33.7652 4.25739 35.9001 -31.2863 -13.3655 20.8802 -4414 4 34.2485 3.80076 36.6104 5.56552 8.36292 -9.80816 -4415 4 32.8077 4.13792 36.1863 30.7439 3.51509 -16.9094 -4416 6 47.9725 16.0636 29.8584 -12.289 -4.0311 -5.35812 -4417 4 48.7208 16.4163 30.3732 -4.13056 -10.8519 0.408936 -4418 4 47.3533 15.5947 30.4559 16.7379 8.85318 -0.563064 -4419 6 49.3385 10.0935 28.5885 -11.8118 4.56009 -13.0989 -4420 4 48.5886 10.6638 28.8239 3.51911 -4.5157 1.44109 -4421 4 49.3924 10.1159 27.6088 6.69909 -1.91925 15.8757 -4422 6 21.4187 27.7693 29.76 2.80336 -20.4787 -6.37736 -4423 4 21.861 27.2354 30.4624 -7.84738 15.6574 -13.8161 -4424 4 21.1828 28.6282 30.0799 2.10219 20.3695 17.9057 -4425 6 11.6757 39.482 25.8517 13.5538 20.9417 -1.29545 -4426 4 12.2965 38.7786 26.0889 -7.12508 -2.9493 -2.05027 -4427 4 10.8193 39.0846 25.7116 -11.9056 -6.20494 0.0112269 -4428 6 22.9798 39.311 7.85817 -12.7601 -4.86939 -3.04246 -4429 4 22.3059 38.6219 7.95844 1.92638 3.98273 0.136758 -4430 4 22.5772 40.0658 8.31757 9.04497 -1.85468 3.82529 -4431 6 42.5415 35.9278 31.3391 13.0935 -70.9729 -20.1514 -4432 4 42.6447 35.4696 30.4714 -5.52665 5.17936 25.8951 -4433 4 42.5102 36.7973 31.0384 -8.93799 60.9387 2.27408 -4434 6 33.663 14.7412 3.98499 30.4225 -17.693 -39.6888 -4435 4 32.8564 15.2185 4.09596 -24.3526 16.5192 2.50389 -4436 4 33.8944 14.7916 3.00116 -11.9532 1.40502 32.6284 -4437 6 36.697 8.6017 17.5153 18.7294 -29.9333 -4.55465 -4438 4 37.1702 7.95911 16.9159 -11.687 24.5338 13.7544 -4439 4 36.2734 9.25409 16.9543 -7.54123 3.80926 -6.08989 -4440 6 20.8295 32.4146 17.3309 -48.7404 -21.5825 11.0081 -4441 4 20.1664 32.9726 16.9048 10.2664 9.72211 -3.82622 -4442 4 20.2271 31.8015 17.8465 35.2036 12.7196 -8.50107 -4443 6 20.7003 35.3218 14.1083 -3.44914 -18.0461 -19.2112 -4444 4 21.3182 35.5386 13.4099 3.08163 2.90557 -13.4495 -4445 4 20.919 35.9437 14.7754 1.56244 13.5022 22.2067 -4446 6 20.2323 2.51936 40.1651 -9.22326 -14.3688 36.1644 -4447 4 19.7926 2.34354 41.0434 13.5524 6.30823 -28.5037 -4448 4 20.7516 1.7186 40.0171 -1.27786 1.50094 -7.75906 -4449 6 15.0477 14.4672 0.24789 12.9865 -5.55034 -72.7807 -4450 4 15.4827 13.6954 41.6877 -12.87 20.0829 29.6139 -4451 4 15.2186 15.2036 41.5094 -2.93016 -13.2387 23.097 -4452 6 24.8149 37.3373 18.5213 2.43631 -2.68492 27.9859 -4453 4 24.4361 37.9203 17.8611 -0.249038 9.91659 1.71419 -4454 4 24.5604 37.6468 19.4234 0.486379 -6.00228 -23.279 -4455 6 3.16989 27.7944 5.24229 1.80682 -16.6913 61.515 -4456 4 2.664 27.92 6.09489 -0.254446 2.50987 -32.3978 -4457 4 4.0252 27.4816 5.63916 -14.135 1.37322 -28.2843 -4458 6 37.1257 39.0598 36.0573 4.58816 40.5807 23.3296 -4459 4 37.5599 39.5885 36.7783 -22.7086 -1.13864 -22.8071 -4460 4 37.5439 38.2379 36.1828 13.5973 -37.3165 -5.96047 -4461 6 41.3477 16.3672 3.84024 25.8131 6.72768 37.2631 -4462 4 41.4431 17.3182 3.89206 -17.3786 8.01961 -13.1803 -4463 4 42.0046 16.1549 4.54461 -14.0821 -19.2698 -21.0799 -4464 6 15.5755 3.1684 35.3585 1.47298 2.70845 -61.2084 -4465 4 15.1145 3.59171 34.5864 10.479 -16.2188 17.3147 -4466 4 15.2032 3.60881 36.0782 -15.9672 22.7619 40.5269 -4467 6 33.1731 24.2438 7.96729 6.41569 -10.7526 14.1331 -4468 4 33.3408 24.6773 7.1445 11.9115 -7.07525 -26.7187 -4469 4 32.5824 24.8707 8.33408 -19.4303 14.6961 21.7816 -4470 6 35.865 29.7374 15.5979 -29.8607 35.3275 -32.1308 -4471 4 36.7747 29.6672 15.7703 43.701 -12.5229 16.5971 -4472 4 35.3562 29.0371 15.9739 2.56537 -15.478 18.0667 -4473 6 17.5843 36.8354 41.8728 12.1708 -5.57123 -52.5088 -4474 4 18.1833 36.773 0.675699 12.2604 -1.93512 36.5948 -4475 4 18.2359 36.8623 41.125 -21.8566 7.06165 11.6698 -4476 6 26.5622 4.14672 31.1307 -32.6289 -51.1506 -31.7953 -4477 4 27.2582 4.59627 31.5457 41.9615 24.0313 17.3243 -4478 4 26.8928 3.23766 30.8727 -4.86114 29.783 15.5489 -4479 6 31.9552 1.33198 34.4369 -14.3248 -8.90334 35.5546 -4480 4 32.7269 1.15305 34.9944 8.32726 6.02564 -17.2377 -4481 4 31.2642 1.08685 35.0838 -0.545778 4.81468 -20.3916 -4482 6 24.491 14.7534 2.38457 33.2042 -23.9469 17.2683 -4483 4 24.2753 13.9637 2.92779 -7.56186 18.0622 -11.5291 -4484 4 25.4626 14.8414 2.55985 -20.2114 8.54272 -9.97318 -4485 6 25.7566 20.9055 27.5389 -1.15091 7.1508 6.95521 -4486 4 25.459 20.6057 28.4261 8.17968 -1.38894 -17.9407 -4487 4 25.6371 21.8685 27.5748 1.97223 -1.15564 -2.97875 -4488 6 18.1445 40.1527 30.6395 17.3729 -20.3781 15.2884 -4489 4 18.5141 39.2638 30.8544 -10.5973 16.1604 -9.36512 -4490 4 18.9393 40.7073 30.6583 -6.94059 7.54086 -5.9327 -4491 6 46.7889 23.8914 24.5979 7.31075 41.4222 -46.8858 -4492 4 46.2898 24.602 24.0741 10.6002 -32.8666 22.2289 -4493 4 47.4121 23.5287 23.9473 -6.99108 -0.957122 4.26591 -4494 6 45.6201 22.6921 26.5067 -14.1777 -10.0967 -12.8229 -4495 4 46.0372 22.9342 25.6668 -2.41585 -1.26552 16.8561 -4496 4 46.0784 23.1676 27.2003 -0.61408 1.28207 1.11474 -4497 6 20.1006 4.48803 26.6974 -40.8522 40.1383 42.8029 -4498 4 20.2489 5.43817 26.4853 8.37449 -26.4011 -0.951475 -4499 4 20.6602 3.93368 26.2205 34.0606 -24.4352 -38.1565 -4500 6 35.278 26.5864 12.552 0.280065 20.4825 10.9931 -4501 4 35.6728 25.7022 12.4634 2.08478 13.3641 8.87461 -4502 4 35.7774 27.1222 13.2104 -5.20465 -19.6779 -15.4464 -4503 6 3.25879 33.9669 12.2907 -5.01808 -25.4739 5.3677 -4504 4 2.34263 33.6224 12.3201 4.20809 12.7539 -0.381501 -4505 4 3.26735 34.9165 12.3326 -4.58918 17.9212 0.78916 -4506 6 36.6873 1.27899 25.5756 -31.8717 2.25298 32.7844 -4507 4 37.6116 1.37326 25.7779 18.4499 5.6721 -4.77344 -4508 4 36.2122 1.51788 26.4163 6.97172 -2.04149 -25.7728 -4509 6 16.8705 4.65685 24.0413 -35.5309 2.76318 -23.9776 -4510 4 15.8575 4.70434 23.9217 47.0687 -0.0954558 1.21401 -4511 4 17.247 4.33879 23.186 -5.50277 -2.28941 17.9023 -4512 6 39.6565 15.0715 7.80572 25.6093 19.6796 32.1194 -4513 4 39.2854 14.2576 8.13712 -9.42359 -13.1845 -9.18942 -4514 4 39.3628 15.2517 6.91527 -5.26665 -12.4192 -5.15573 -4515 6 9.97948 20.1659 2.91877 -9.38613 14.9664 11.2777 -4516 4 9.63877 20.6452 2.15027 4.12295 -11.9706 -3.67253 -4517 4 9.85969 19.2106 2.80597 1.71997 13.0916 -4.74013 -4518 6 23.4135 4.6314 15.2717 1.19087 -47.3757 24.1847 -4519 4 23.6596 4.57091 14.3636 3.27412 12.4021 -25.8415 -4520 4 23.0767 5.481 15.4712 -5.64379 31.4202 -0.243197 -4521 6 23.5143 41.6409 17.9193 15.1077 8.25095 -6.6202 -4522 4 23.8837 41.2632 18.7444 -17.9015 4.85421 -1.14363 -4523 4 22.6477 0.129763 18.1032 2.89941 -5.9973 3.37217 -4524 6 30.9257 4.8197 1.33225 52.4556 82.2644 21.8498 -4525 4 30.6067 4.04082 1.0087 -28.5575 -73.6424 -29.1188 -4526 4 31.8008 4.99709 0.898826 -20.2281 -12.9509 7.44496 -4527 6 29.2107 33.7595 18.6102 73.0072 -21.2941 -2.29721 -4528 4 30.2072 34.0216 18.5444 -47.9733 -6.17517 5.28057 -4529 4 28.7323 34.5281 18.37 -21.0864 31.3556 1.11974 -4530 6 23.1159 16.7161 3.6681 15.0693 -22.2232 4.2808 -4531 4 23.7494 16.3853 2.99745 -15.1451 3.0429 8.25243 -4532 4 23.0882 17.666 3.59926 -2.15966 11.8771 -4.335 -4533 6 34.9011 26.7664 31.7501 -1.76717 8.52767 -40.8429 -4534 4 35.037 27.6398 31.3273 1.29043 -2.59798 26.5044 -4535 4 34.999 26.223 30.9552 -0.698038 -3.54606 8.98008 -4536 6 7.10213 40.7731 20.9713 24.4432 1.2064 -5.23395 -4537 4 6.57619 40.3882 20.2802 -20.054 -4.79313 -9.64846 -4538 4 7.95521 40.8692 20.51 0.818491 4.17448 7.60026 -4539 6 52.4557 9.69054 11.9333 -13.8891 -19.4181 -13.3487 -4540 4 52.1298 8.88818 11.4535 9.48574 25.0976 13.8313 -4541 4 53.1611 10.0725 11.3936 -7.122 -1.8527 1.23238 -4542 6 12.0235 32.7598 27.7442 3.70099 -7.78602 -3.89203 -4543 4 11.3626 32.1501 27.3892 -5.86407 9.3821 3.02313 -4544 4 12.7405 32.6461 27.1218 9.18069 3.19616 2.31322 -4545 6 15.7918 18.546 0.850378 10.8461 -1.95532 -11.5883 -4546 4 16.438 18.9813 1.41668 1.29405 -2.87095 0.147979 -4547 4 14.9753 18.6242 1.3119 -21.1882 -0.0291689 9.92309 -4548 6 30.9967 13.9378 7.42939 11.475 1.61738 -44.5395 -4549 4 31.0432 13.5913 6.48715 -7.7997 1.97415 36.5778 -4550 4 31.6719 14.6391 7.43931 -7.46887 -7.66354 10.6483 -4551 6 23.9383 39.564 3.55488 34.3001 -22.0749 -10.0269 -4552 4 24.3437 38.8163 4.07249 -17.2972 16.8542 -11.2744 -4553 4 24.6493 39.7352 2.88999 -19.8697 7.819 10.5959 -4554 6 53.2452 13.9576 2.00229 -14.7116 -5.90049 -8.44118 -4555 4 54.0493 14.3984 2.24709 19.6807 0.169927 9.22775 -4556 4 52.9645 14.4205 1.20429 2.95034 -7.59818 -1.70329 -4557 6 29.4557 26.4275 7.80964 12.1022 6.02758 -9.79702 -4558 4 29.9353 26.7368 7.00545 -17.6775 -4.91001 19.2628 -4559 4 28.525 26.2807 7.58748 -5.08244 6.84096 -3.37299 -4560 6 24.6247 23.6022 31.0889 -22.8452 23.3962 -39.3716 -4561 4 23.7242 23.1866 30.9343 31.0198 16.8155 5.56769 -4562 4 24.7802 24.3072 30.3632 -7.32447 -41.3429 34.091 -4563 6 33.6649 19.3163 40.5091 -6.65541 -1.27585 7.81728 -4564 4 33.8354 18.657 41.2044 -1.67667 1.74775 -3.87809 -4565 4 34.3105 19.1562 39.8145 2.0445 4.20075 -4.1701 -4566 6 0.559384 35.9874 14.2134 5.8565 -19.6842 -1.82955 -4567 4 1.23941 35.9463 14.8996 -3.202 15.0395 2.84586 -4568 4 0.030681 36.7785 14.2979 -4.01885 14.7851 6.49139 -4569 6 7.05661 12.759 15.7779 -22.8667 -6.52104 17.6379 -4570 4 6.34583 12.5966 16.4564 20.9558 0.33122 -21.552 -4571 4 6.91757 12.0848 15.0954 -2.34629 3.44815 6.08752 -4572 6 7.88282 3.87818 22.4173 5.89555 -44.5054 15.1514 -4573 4 7.49019 4.56914 21.9267 -7.80716 26.896 -25.5563 -4574 4 7.61791 3.03791 21.9647 5.08594 18.6769 15.1101 -4575 6 50.7471 32.0888 16.2401 1.83727 42.1646 -7.06137 -4576 4 49.8752 31.8312 16.5285 -7.29916 -4.21179 -0.512004 -4577 4 50.6362 33.057 15.9791 5.96194 -37.4522 8.78354 -4578 6 15.303 18.2089 30.059 10.7923 -22.0796 25.2673 -4579 4 14.9011 18.5061 29.2675 -14.0638 14.0876 -27.3921 -4580 4 14.9173 17.3208 30.1974 9.34767 8.93092 3.04247 -4581 6 36.7231 25.4597 33.3812 -54.2725 16.2506 -34.9161 -4582 4 35.9173 25.838 32.8237 55.5216 -11.0114 39.6871 -4583 4 36.747 24.5432 33.1027 5.79642 -6.85026 5.14009 -4584 6 16.5358 21.8507 20.2615 -17.2006 3.10996 -10.5852 -4585 4 16.5318 20.9271 19.9881 4.62491 -6.39719 -1.16283 -4586 4 16.2171 22.3466 19.4835 8.40466 -0.269645 8.83911 -4587 6 44.2784 3.11614 30.075 -4.29151 -10.9085 31.9498 -4588 4 44.2908 2.23086 29.7056 -5.3385 -9.83615 -1.81045 -4589 4 44.5205 3.68982 29.3775 9.49019 22.102 -29.428 -4590 6 51.0822 14.1295 27.7742 -18.732 -33.3382 -1.30318 -4591 4 51.215 15.0658 27.7997 -1.99026 24.8352 -0.164216 -4592 4 50.1181 13.9695 27.6298 18.0185 9.91077 0.913588 -4593 6 54.1414 15.8836 27.1251 18.1892 -50.717 -21.9912 -4594 4 54.5758 14.9905 27.2793 -7.90108 34.3346 13.352 -4595 4 53.8259 15.7459 26.2068 -12.5208 17.6482 15.4671 -4596 6 26.7107 15.1629 34.529 26.3006 32.6175 -12.2305 -4597 4 26.7089 16.144 34.4655 -8.86078 -18.0829 7.52702 -4598 4 27.5163 14.9973 34.009 -10.4907 -11.0891 -0.654257 -4599 6 34.6699 2.22267 27.4725 27.1341 -12.2799 29.337 -4600 4 34.3153 1.93716 28.3227 7.08088 3.88889 7.09202 -4601 4 33.8991 2.25298 26.9555 -28.541 9.30381 -28.496 -4602 6 36.3083 17.6409 40.3953 7.68303 1.60807 9.57574 -4603 4 35.716 17.1791 39.8253 -12.5236 -4.37947 -14.4862 -4604 4 36.6569 16.9265 40.9504 1.18426 15.263 2.6664 -4605 6 26.2972 0.194896 33.0957 0.945324 -1.75644 -10.1569 -4606 4 26.0926 0.771392 33.8475 -8.68516 2.0119 1.91424 -4607 4 25.4691 41.6865 32.8295 -8.00507 -1.67316 12.192 -4608 6 5.19113 35.5773 31.6357 23.2413 -27.7984 27.0466 -4609 4 6.1476 35.7159 31.7435 -10.1506 4.22761 6.12862 -4610 4 4.96861 36.095 30.8978 -11.7512 22.2076 -38.0194 -4611 6 20.2191 22.0354 35.1304 9.30742 -6.19625 19.4235 -4612 4 19.9844 21.2003 34.7289 -5.16022 -6.81034 -3.33987 -4613 4 20.4782 21.7596 36.0473 -3.02096 9.85719 -25.9724 -4614 6 15.9251 36.5949 36.947 -9.13121 -30.7472 31.1466 -4615 4 16.4837 37.3712 37.0549 6.13876 -3.03661 -2.05614 -4616 4 16.031 36.0658 37.8159 -5.1453 16.1721 -39.9007 -4617 6 30.9484 22.4015 3.56131 11.993 -60.8988 -15.4947 -4618 4 31.1008 22.6958 4.44557 1.55935 5.74187 27.4751 -4619 4 31.2551 21.4217 3.58407 -13.4398 43.4536 -6.61432 -4620 6 47.0429 8.40936 14.2086 -4.42011 -15.6298 -34.0486 -4621 4 46.2603 8.29509 13.606 17.325 5.05196 18.7602 -4622 4 47.7698 7.89697 13.7682 -18.8904 11.0332 12.0247 -4623 6 34.1011 18.6159 3.148 0.361877 23.965 35.4915 -4624 4 34.6363 18.3397 3.89922 -0.845538 -0.743075 -4.07575 -4625 4 34.3812 18.1265 2.40098 2.04544 -17.9565 -29.3984 -4626 6 26.7996 25.3961 12.3408 -30.8906 -54.2954 26.5725 -4627 4 27.3117 26.1608 12.4557 20.536 44.4803 3.39785 -4628 4 26.6414 25.0259 13.2528 6.28377 9.49183 -30.6151 -4629 6 22.6108 25.7845 30.8845 17.3255 -0.303924 3.7754 -4630 4 23.4288 25.6954 31.4132 -11.344 -1.13015 -1.03332 -4631 4 22.2314 24.9052 30.7722 1.09512 -5.6623 7.4309 -4632 6 23.6311 9.76276 35.7585 -2.90797 -4.19552 -4.78319 -4633 4 22.8314 10.2832 35.6581 -5.74139 5.63622 4.02691 -4634 4 23.3139 8.86685 35.4998 11.2809 19.0625 6.63709 -4635 6 10.4076 36.7742 9.64242 -28.436 -9.9846 9.32351 -4636 4 9.50067 36.3875 9.59353 19.7531 11.7612 -0.53903 -4637 4 10.7226 36.8301 8.7426 3.69205 5.92187 -13.8772 -4638 6 4.00038 32.4265 25.8669 22.0714 10.4661 11.4497 -4639 4 4.38844 32.9375 25.1422 -1.34031 3.54398 1.69886 -4640 4 3.2706 31.9516 25.4996 -17.8371 -17.4963 -10.4987 -4641 6 29.085 26.0296 18.6527 19.273 -47.5776 11.2122 -4642 4 28.2115 26.0231 19.0264 -21.1607 3.13806 -0.423844 -4643 4 29.4632 25.1291 18.9323 -7.10954 42.4601 -14.5827 -4644 6 15.3089 1.3255 27.9792 -24.1234 20.5069 -17.5654 -4645 4 15.0496 0.974163 27.1169 2.04641 -4.01433 11.5068 -4646 4 14.7355 2.12388 28.0804 19.9995 -12.8223 4.08523 -4647 6 48.6106 2.88816 22.9655 -1.26722 3.55247 -0.201848 -4648 4 48.4165 2.02818 22.6182 -14.5439 -12.5884 3.03438 -4649 4 49.5001 2.98572 22.6432 10.4652 10.9023 -5.33271 -4650 6 53.0075 0.36099 19.7296 11.424 -8.43987 -8.95848 -4651 4 52.5965 41.9022 20.5162 -3.41206 4.78179 6.33318 -4652 4 52.3731 0.223553 19.0136 -6.83989 5.16364 0.289704 -4653 6 1.41074 17.5036 17.9462 -15.7932 -16.9445 -5.36496 -4654 4 1.29993 17.3585 17.0019 -2.92928 12.5396 -5.88676 -4655 4 1.38271 16.6004 18.2823 6.65411 -3.00458 14.0519 -4656 6 37.9084 19.0323 37.6056 -38.9323 8.68785 -13.5971 -4657 4 36.9858 18.7285 37.7384 11.3307 8.89304 -0.372118 -4658 4 38.4207 18.4342 38.1195 19.3518 -17.7067 16.118 -4659 6 26.9813 30.3571 38.0896 -0.527767 18.5171 -30.3811 -4660 4 26.1212 30.285 37.6565 1.23907 -9.17466 9.80696 -4661 4 27.2764 31.2069 37.701 2.1524 -13.2267 12.8694 -4662 6 20.0955 18.5722 3.03696 10.9017 21.9571 9.92937 -4663 4 20.0263 17.806 3.59422 -10.4522 -23.2015 2.62566 -4664 4 20.8322 19.0363 3.46766 -4.52129 0.073665 -16.3651 -4665 6 35.0841 6.94694 4.08385 8.40312 -14.6319 10.4582 -4666 4 35.6826 7.16069 3.3578 -1.64356 4.34706 -6.00978 -4667 4 34.2613 7.42764 3.99145 -7.61312 4.93718 -6.31016 -4668 6 22.2176 37.0878 31.2599 -35.8324 13.882 69.7054 -4669 4 22.1593 36.8558 30.3798 -4.04212 -13.8909 -61.3413 -4670 4 21.2552 37.1952 31.5589 44.4461 1.84169 -14.4682 -4671 6 12.3904 22.3711 41.8265 33.9103 21.3816 -17.5574 -4672 4 13.0623 23.0096 41.4404 -31.3175 -17.017 24.3472 -4673 4 11.7392 22.2302 41.1411 -5.71588 1.3909 -0.895108 -4674 6 43.2333 30.3145 23.1566 26.412 30.0652 1.94466 -4675 4 44.1443 29.9954 22.911 -23.9673 11.2944 4.28313 -4676 4 43.3588 31.2906 23.3811 -4.98348 -33.6726 -4.24118 -4677 6 16.5316 8.07904 16.6592 -13.1305 -2.58289 1.30551 -4678 4 16.426 8.46358 15.7881 -7.07274 -4.02537 -8.52635 -4679 4 17.4421 8.27811 16.8595 11.8389 2.77268 11.6749 -4680 6 10.0527 8.64979 31.7837 -8.97334 17.7557 -57.5223 -4681 4 10.1312 7.90747 32.3291 5.58005 -27.1767 37.8097 -4682 4 10.1183 9.47003 32.2578 1.92783 9.29621 23.4619 -4683 6 10.1389 6.52097 25.6279 25.2027 -9.57639 0.964906 -4684 4 9.42987 6.19895 26.1639 -19.2857 -8.54063 7.31181 -4685 4 9.7626 7.17299 25.0306 4.07146 -2.80849 4.96109 -4686 6 49.8614 7.23714 25.5252 -17.9172 7.62946 -5.56104 -4687 4 50.0467 6.31121 25.4422 2.69032 -18.6529 -6.42341 -4688 4 50.6907 7.63095 25.75 18.9978 12.6416 8.6826 -4689 6 18.4677 37.5766 33.9365 -27.5019 7.45217 1.11424 -4690 4 17.6855 38.1606 34.0956 24.1544 -3.52274 -4.16364 -4691 4 18.0518 36.7105 34.0373 4.53854 -5.63623 -1.47673 -4692 6 32.1991 34.7999 39.2511 37.7035 -28.7103 22.0041 -4693 4 32.3976 34.2973 40.087 0.14143 15.1618 -21.7552 -4694 4 31.3182 35.0784 39.3573 -42.2601 10.9481 4.26487 -4695 6 49.5371 23.9083 4.45427 26.1113 1.30104 -36.4507 -4696 4 49.7626 23.2251 5.06121 8.22711 -23.3511 16.8473 -4697 4 48.7895 24.3154 4.8182 -37.5883 23.1909 21.4935 -4698 6 6.05615 24.4755 33.9372 -3.62864 21.1406 1.2609 -4699 4 6.78781 23.8493 33.8811 -5.98028 -5.90455 -1.42734 -4700 4 5.44033 24.2071 34.6424 10.5748 -4.32926 -7.84557 -4701 6 1.71417 22.9797 24.1919 12.9465 25.751 -13.942 -4702 4 1.74027 23.9063 23.8744 -7.21984 -9.04225 7.93975 -4703 4 0.785802 22.7901 24.3299 -10.4675 -5.82386 8.34916 -4704 6 12.4544 16.5695 32.338 -33.1179 2.9171 31.5337 -4705 4 13.1434 15.995 32.5512 52.391 -27.2499 -12.3732 -4706 4 11.9701 16.4097 33.1768 -13.251 25.8897 -21.4653 -4707 6 21.3776 37.3784 27.9508 -6.73969 12.2577 23.3137 -4708 4 21.2203 37.3231 27.0262 1.16773 -1.52428 -34.5533 -4709 4 20.718 38.0458 28.2038 6.71566 -1.73666 8.03222 -4710 6 27.2299 40.8388 28.8031 2.48401 0.937021 1.60569 -4711 4 26.5367 41.5089 28.9565 6.65702 -12.2841 2.86921 -4712 4 27.4065 40.3185 29.6035 -12.9999 8.55112 -0.224288 -4713 6 0.993205 21.7261 13.5372 -53.3037 2.48171 -36.3839 -4714 4 1.86429 21.8093 13.8237 52.7771 -6.56786 29.3883 -4715 4 0.417346 21.4203 14.2472 8.63216 3.11646 10.526 -4716 6 22.3067 2.58146 8.73662 29.448 -13.2509 35.6107 -4717 4 22.9722 3.05705 8.24165 5.16658 9.50374 -8.2335 -4718 4 21.5154 2.5876 8.23764 -24.8297 4.23497 -21.3736 -4719 6 29.9953 17.8456 8.24313 -2.433 8.62767 -9.90081 -4720 4 29.054 17.6713 8.30654 -5.44558 -4.70631 2.21427 -4721 4 30.3746 17.4275 9.01982 5.69521 -3.15286 8.62416 -4722 6 3.62819 37.7118 25.7099 -17.1271 -24.8271 -10.3244 -4723 4 4.40422 37.1524 25.7956 9.9921 4.76654 4.66524 -4724 4 2.941 37.0477 25.4485 4.12723 25.8155 6.09629 -4725 6 26.809 27.648 36.3589 -37.7802 -17.2474 29.8166 -4726 4 26.8014 28.1831 35.5758 -1.13827 16.217 -13.4241 -4727 4 25.8725 27.5642 36.7259 28.3017 7.35189 -21.1707 -4728 6 13.3559 25.3099 38.116 1.93465 -14.8526 16.0582 -4729 4 13.2959 24.3789 38.4372 3.98877 20.6101 -4.99041 -4730 4 14.1146 25.694 38.605 -5.66874 -3.07699 -9.11419 -4731 6 49.7048 27.2599 6.72622 -1.43928 22.3256 -10.7839 -4732 4 49.6686 26.3369 6.45132 -5.99645 4.70457 -4.8273 -4733 4 49.2845 27.8697 6.04945 8.54794 -27.7312 19.0533 -4734 6 39.7449 11.5776 10.1987 6.84991 -8.95817 -1.04181 -4735 4 40.3059 10.8428 9.86803 -8.86198 19.4731 1.33094 -4736 4 39.0907 11.7833 9.50723 6.52335 -1.56097 1.75374 -4737 6 17.4857 24.9907 35.5559 -11.6728 -0.232318 -1.23817 -4738 4 17.2359 24.7743 34.6481 -9.71541 0.96097 3.2925 -4739 4 18.4326 24.9281 35.5495 18.729 -4.76527 0.24637 -4740 6 45.0886 34.9858 31.8393 -13.7853 -2.59791 -12.3576 -4741 4 44.2542 35.4282 32.0247 4.31579 11.0194 10.5125 -4742 4 44.8031 34.4855 31.0733 13.3341 -13.9746 -4.20839 -4743 6 30.2109 9.89077 31.3202 8.39813 20.0527 10.0978 -4744 4 30.4343 10.7522 30.9233 -1.69236 -11.2354 5.34707 -4745 4 30.0976 10.0887 32.2697 2.61193 -8.5831 -6.90929 -4746 6 32.3748 9.22464 6.61109 37.8815 -39.2378 -50.8405 -4747 4 32.2118 8.68084 5.76454 4.57858 20.451 35.1159 -4748 4 31.5433 9.4233 6.96427 -45.6188 15.529 19.6617 -4749 6 9.26845 24.9782 35.9229 1.19564 -9.02769 -15.4958 -4750 4 8.9564 25.4582 35.1216 5.49795 -4.99978 19.1154 -4751 4 9.87718 25.5584 36.4061 -8.42028 -2.10732 -11.5846 -4752 6 40.3335 1.48296 18.8902 20.9136 0.652934 -58.3414 -4753 4 39.6207 1.94237 19.2768 -32.228 11.5513 31.9135 -4754 4 40.836 0.952532 19.4949 5.43911 -12.9068 21.333 -4755 6 5.27733 10.6166 30.4293 -4.37857 29.6514 35.8012 -4756 4 5.00531 11.4476 30.0112 -0.880507 -1.63534 -8.13264 -4757 4 5.35863 10.9185 31.3957 -0.759826 -20.4729 -25.7258 -4758 6 25.6655 11.6994 25.6535 -15.8411 -39.3949 6.40341 -4759 4 25.8392 12.448 26.1908 9.94197 23.9877 11.5846 -4760 4 25.8146 10.9427 26.2759 4.01869 23.17 -23.7809 -4761 6 21.9208 20.0736 29.783 -0.661059 -23.1285 25.9828 -4762 4 22.5528 19.9674 30.5279 -9.0028 12.6586 -11.845 -4763 4 21.4796 19.2024 29.7633 3.30396 8.80601 -15.8778 -4764 6 10.0031 19.9894 34.5062 10.0701 -18.9504 -1.84201 -4765 4 9.43917 20.4787 35.093 -9.85162 7.82768 6.06887 -4766 4 9.97528 19.0642 34.823 3.96148 11.1077 -9.79004 -4767 6 24.6395 10.3611 12.2013 10.4056 19.7725 40.7349 -4768 4 24.7062 9.53294 12.699 -2.91134 1.50973 -12.3578 -4769 4 25.0089 11.0108 12.8733 -15.5791 -20.8054 -25.2752 -4770 6 50.4386 28.2959 11.551 52.3964 -11.4141 -41.8896 -4771 4 51.2944 28.7096 11.1811 -37.3824 -15.4271 20.8858 -4772 4 50.1484 28.8694 12.238 -9.02874 19.1251 18.783 -4773 6 13.9255 27.6321 25.0575 -30.7043 9.27758 -16.9407 -4774 4 13.4685 27.961 25.8505 6.53671 1.50814 -8.33226 -4775 4 13.405 28.0084 24.2853 19.6442 -13.6277 24.9436 -4776 6 46.1675 18.6723 40.4127 -24.7255 0.52235 -5.51451 -4777 4 45.2163 18.6287 40.1471 17.8616 -3.70574 0.193046 -4778 4 46.2526 19.5549 40.792 -2.63441 -2.56699 -8.45512 -4779 6 32.4875 14.1744 27.1342 -20.1773 -0.115465 -0.458595 -4780 4 31.894 13.6021 27.6676 10.0212 10.5514 -7.27374 -4781 4 32.1329 15.0809 27.2203 4.74838 -8.22403 2.71507 -4782 6 14.0641 36.351 13.3878 -9.69625 43.6715 -7.48797 -4783 4 14.0645 37.3444 13.3555 12.262 -25.9465 20.9036 -4784 4 13.2835 36.2347 12.8457 -5.28255 -22.0231 -7.64651 -4785 6 1.89477 36.5899 21.9857 -12.7075 -7.68583 0.53673 -4786 4 1.75133 36.5712 22.9388 2.01013 -3.06644 8.01032 -4787 4 2.81569 36.8315 21.8421 3.36212 -1.19737 0.805445 -4788 6 25.2943 31.8607 39.7417 -2.48011 0.614033 34.0265 -4789 4 24.999 32.7283 39.4716 -5.73903 6.77443 -6.35095 -4790 4 25.461 31.9431 40.7124 0.191009 -4.33082 -23.8473 -4791 6 6.4797 22.0186 1.29894 -12.0535 -14.7769 -6.17691 -4792 4 5.53353 21.8063 1.36197 11.0348 5.26157 5.70773 -4793 4 6.5732 22.8347 0.80957 1.58971 11.8894 0.78955 -4794 6 27.6266 25.0275 4.69979 7.76412 30.8855 29.066 -4795 4 28.5017 25.4862 4.66738 -16.9061 -15.4428 -5.02391 -4796 4 27.2115 25.3905 5.52919 8.95609 -10.8934 -21.2922 -4797 6 21.6474 30.9429 41.2213 -14.674 16.9935 -31.5335 -4798 4 21.3077 30.3434 41.8509 -10.7705 -24.5884 29.0962 -4799 4 20.9035 30.9616 40.5667 22.5963 5.39714 5.21952 -4800 6 32.3503 18.8691 12.7728 -7.52429 -0.383917 -18.241 -4801 4 31.3918 18.9773 12.8161 6.27066 1.36054 6.85895 -4802 4 32.4619 18.5656 11.8564 12.6246 0.663961 8.91714 -4803 6 35.6352 19.4593 21.1461 -10.1734 29.4522 17.7801 -4804 4 35.3511 18.62 21.5049 -2.07097 -11.6796 -4.30053 -4805 4 34.9906 20.1214 21.5255 16.9121 -20.2959 -15.2058 -4806 6 27.6974 17.9478 34.0105 3.72497 22.7808 11.4532 -4807 4 28.1244 18.3695 33.2449 -3.6365 -3.33971 3.70746 -4808 4 28.0134 18.5196 34.7467 -3.33496 -14.4526 -11.1074 -4809 6 34.1722 39.0415 14.8025 -0.588556 -5.09353 50.87 -4810 4 33.8492 38.3378 14.2426 -9.69809 -4.78927 -2.35124 -4811 4 33.6075 39.0103 15.6476 14.9636 10.6202 -38.8415 -4812 6 28.5063 3.47722 33.8826 -13.8698 -21.2799 4.06498 -4813 4 27.871 4.20321 33.9085 6.20243 8.28698 -1.91661 -4814 4 29.4175 3.76621 33.9059 10.9167 16.0273 -3.84391 -4815 6 34.9231 32.1486 6.55347 -48.5451 -22.9266 3.43697 -4816 4 33.9921 31.9748 6.9467 49.872 11.9331 -17.2337 -4817 4 35.5478 32.1135 7.28146 1.17984 3.66225 6.53991 -4818 6 31.8923 6.87344 23.517 2.73099 13.3553 4.48118 -4819 4 32.4005 6.72509 22.7097 -0.163961 -9.68163 3.8586 -4820 4 32.2042 7.75277 23.812 -2.19309 -5.80853 -1.60196 -4821 6 18.8495 1.74691 0.846251 -10.8424 6.73855 -33.2301 -4822 4 18.128 2.12906 0.287715 7.30697 -5.37966 19.0723 -4823 4 19.1812 2.42034 1.43504 -3.90896 9.02122 12.2654 -4824 6 27.0029 18.9235 11.8738 61.7268 20.0146 -35.0636 -4825 4 27.2277 19.7644 11.4142 7.64396 -16.2258 9.71345 -4826 4 26.1059 19.0334 11.9849 -72.3018 -1.47246 20.779 -4827 6 43.8315 11.1413 18.4425 12.0955 7.77381 31.2403 -4828 4 43.582 10.9955 17.5403 1.6883 -14.8273 -19.2234 -4829 4 44.4878 10.475 18.7348 -4.89818 7.49251 -15.5557 -4830 6 33.4942 40.5585 37.6724 7.87983 -3.11064 16.6213 -4831 4 33.9456 40.2455 38.4765 5.57637 6.44045 -9.71494 -4832 4 32.6057 40.2384 37.8499 -11.5443 1.61602 -9.31227 -4833 6 15.6218 26.7049 39.4143 -33.8245 -53.4627 11.7102 -4834 4 15.4245 26.9754 40.2985 -0.693124 5.44593 20.3253 -4835 4 16.1216 27.3809 39.0562 36.6223 43.7441 -31.7418 -4836 6 4.38199 13.876 40.8778 6.07973 -11.0772 -3.70535 -4837 4 5.33347 13.6897 41.0138 -14.6737 -0.272428 -1.39073 -4838 4 4.02273 13.2235 40.2449 7.64869 11.7946 8.98025 -4839 6 20.1779 10.396 38.2135 -21.4206 4.43784 1.78325 -4840 4 20.3564 10.9148 37.4134 10.9013 -11.3706 0.559506 -4841 4 20.991 10.2443 38.6984 6.99273 1.77474 -1.94206 -4842 6 15.1578 19.2491 23.8705 6.70925 0.197906 -4.49513 -4843 4 15.3523 20.1614 24.134 -1.79925 -4.44488 8.10361 -4844 4 15.0598 19.3463 22.9079 -1.20619 -5.61783 14.9214 -4845 6 47.881 28.6148 15.8048 16.8356 22.7469 11.8397 -4846 4 48.0602 27.74 15.4965 -2.52866 -23.0751 -5.40804 -4847 4 48.6281 28.8091 16.402 -10.5906 -5.01786 -6.93826 -4848 6 29.925 30.905 18.9707 11.7406 3.33263 -1.10353 -4849 4 29.0879 30.4807 18.764 -8.84985 -7.33813 -1.92291 -4850 4 29.807 31.8375 18.7873 -6.04184 4.11832 2.37084 -4851 6 11.9324 35.8064 28.512 -27.4265 24.0258 -21.7564 -4852 4 12.5706 36.1347 29.1334 15.2736 -4.81493 21.8335 -4853 4 12.2236 34.9831 28.145 8.79196 -20.6768 -0.490374 -4854 6 29.967 37.8624 25.4885 4.59009 -4.14727 -0.313094 -4855 4 30.2605 37.0012 25.8228 -4.78695 -0.224547 -14.1967 -4856 4 30.4431 38.4647 26.0537 0.190265 15.5785 7.27405 -4857 6 52.6385 28.1101 32.2696 27.4129 -14.0906 14.429 -4858 4 52.1837 28.8064 31.8018 1.35463 13.918 -3.63194 -4859 4 53.5572 28.4115 32.4361 -8.8806 -0.527566 -10.0859 -4860 6 37.0194 40.0856 11.9811 12.8522 -14.0915 -8.99985 -4861 4 36.2698 40.6335 12.1547 -20.3135 9.86443 5.11387 -4862 4 37.3206 39.8255 12.8594 7.06858 1.59634 4.17732 -4863 6 16.6823 16.7862 36.5016 -40.0159 24.4695 -22.7659 -4864 4 15.9639 17.4464 36.7433 30.1481 -22.6997 -3.51596 -4865 4 16.709 16.8774 35.5181 2.88256 -1.64708 20.873 -4866 6 28.0056 4.17661 38.8341 -15.1907 4.44859 15.1459 -4867 4 28.8664 4.34511 39.2253 10.7528 -1.70638 -4.98709 -4868 4 28.1362 3.72531 37.9969 -2.54795 -6.06729 -7.91519 -4869 6 28.9121 0.2613 17.7196 11.2429 43.6022 -6.13696 -4870 4 28.206 0.913023 17.5432 1.57334 -10.0134 0.986336 -4871 4 28.5175 41.3357 17.883 -22.7122 -29.353 3.51833 -4872 6 22.9275 20.1119 26.272 10.3141 -17.1908 1.54721 -4873 4 23.597 20.0083 26.9758 -6.33812 5.26805 -6.32666 -4874 4 22.343 20.8217 26.5441 4.5912 8.26641 6.04785 -4875 6 49.4104 29.8887 13.4211 -27.0365 40.5227 7.20695 -4876 4 49.0994 30.824 13.2506 14.963 -27.7355 -0.582388 -4877 4 48.6865 29.5209 13.9525 8.18699 -4.12202 2.86767 -4878 6 2.45827 24.8307 7.29137 -22.8365 1.45709 37.207 -4879 4 2.32025 24.5445 8.23446 11.0976 11.5137 -22.649 -4880 4 1.77037 25.516 7.1857 7.09177 -11.7652 -6.70138 -4881 6 30.3948 26.4611 14.3404 -21.8067 20.3233 2.80707 -4882 4 31.1122 26.3224 14.9982 -12.4575 10.0222 -1.69757 -4883 4 29.8137 27.2743 14.5309 34.7851 -33.9666 2.2264 -4884 6 27.0321 32.5068 3.14827 -14.3662 17.1598 1.60641 -4885 4 26.4039 33.1156 3.62616 22.1531 -16.0826 -13.2832 -4886 4 27.3831 31.9163 3.82559 -1.71579 -4.01879 3.19031 -4887 6 34.2634 14.7959 1.27313 2.99828 -7.05923 -10.0889 -4888 4 35.1835 14.4352 1.19997 -20.4533 4.23129 -4.55267 -4889 4 33.713 14.3258 0.588346 24.9828 8.52884 21.9593 -4890 6 30.022 8.54163 1.32868 -10.2939 -13.069 16.6852 -4891 4 30.0052 9.45247 1.0409 -5.08902 11.4157 2.73646 -4892 4 29.2496 8.43498 1.92915 15.9692 5.13326 -10.6744 -4893 6 42.5647 11.5185 27.7103 -4.68909 6.08661 -3.61857 -4894 4 42.216 12.3928 27.8946 9.09127 8.642 -2.18095 -4895 4 41.8714 10.9656 28.0604 -6.00702 -16.6262 4.78299 -4896 6 52.461 39.5492 17.8365 12.2605 -26.0754 -32.0817 -4897 4 51.7553 39.7908 18.3861 -39.7898 9.50592 28.6027 -4898 4 53.1226 40.1801 18.0155 30.5873 23.5517 5.0779 -4899 6 33.2136 4.91918 31.6183 -6.56942 36.6821 16.923 -4900 4 32.9061 5.86322 31.5606 3.78329 -26.1329 5.01225 -4901 4 32.8884 4.48208 30.835 -2.61462 -3.20134 -11.4125 -4902 6 6.2936 16 18.7476 -12.5252 7.31014 22.9936 -4903 4 5.79227 16.5246 19.4216 24.8679 -4.64947 -16.2991 -4904 4 5.64136 15.3462 18.514 -6.08951 -9.62478 -9.34051 -4905 6 8.52033 14.5365 24.6875 -9.84601 3.26611 -2.01077 -4906 4 9.36791 14.3624 25.0978 6.86066 0.30113 1.47813 -4907 4 8.18366 13.6846 24.3866 1.77672 -1.96336 3.84573 -4908 6 22.6911 10.1297 32.1351 -27.5214 -52.5729 10.3709 -4909 4 22.3884 10.9899 32.3649 2.47289 32.4289 -2.22619 -4910 4 23.5203 10.1223 31.6812 20.4751 21.0076 -14.9216 -4911 6 11.292 2.12704 14.679 -26.9964 -14.1635 0.457424 -4912 4 10.3004 2.01295 14.5746 25.662 7.6895 -7.09692 -4913 4 11.7079 2.38272 13.8392 -0.157448 -3.91762 -7.39795 -4914 6 44.9096 15.591 36.2717 33.6405 -1.91298 -30.8875 -4915 4 45.0764 15.4828 35.303 -3.33411 7.1012 27.4883 -4916 4 43.99 15.446 36.3379 -31.2371 -2.78707 10.2167 -4917 6 9.72465 19.0179 31.2227 19.6005 -24.8416 -16.8371 -4918 4 10.5897 19.4265 31.3159 1.30764 -1.40065 3.11778 -4919 4 9.11252 19.5759 31.653 -23.8989 17.913 16.8503 -4920 6 51.9714 7.58847 16.6881 21.0297 -20.8952 -55.8985 -4921 4 52.6598 6.90966 16.567 -10.1825 8.15334 22.1112 -4922 4 51.6538 7.5728 15.7392 -8.87714 21.5211 34.751 -4923 6 31.4317 34.7753 36.422 -0.942044 -9.40807 -31.2122 -4924 4 31.7249 34.7672 37.3268 6.30465 10.9632 14.3566 -4925 4 31.2441 35.6593 36.0754 6.17504 10.5044 11.3925 -4926 6 4.22663 15.0937 15.3657 -12.9272 -11.1361 22.285 -4927 4 4.10058 14.8824 16.3208 1.18356 5.05287 -17.269 -4928 4 5.17453 15.1773 15.2713 12.4851 5.61025 -4.39011 -4929 6 47.7531 20.6767 28.0224 11.2198 -3.02063 -12.9376 -4930 4 47.6925 19.771 27.6598 -2.10862 13.919 9.51432 -4931 4 48.3916 21.1163 27.4231 -12.1395 -0.81062 10.3277 -4932 6 15.815 1.15165 24.4078 -58.142 17.9603 -16.0616 -4933 4 15.2825 0.557615 24.9446 12.6892 -15.3828 1.22604 -4934 4 15.0545 1.63036 23.9524 41.7436 -8.72437 9.7488 -4935 6 34.5811 39.7067 40.0776 25.1973 35.6425 -42.1699 -4936 4 34.2041 40.3093 40.7031 -18.6223 -6.05265 24.4589 -4937 4 34.3171 38.8242 40.1905 -21.7766 -38.3424 16.3885 -4938 6 20.1959 32.1778 34.4064 -21.1308 28.8301 22.4919 -4939 4 19.7756 32.8897 35.0113 13.9702 -37.934 -23.8567 -4940 4 21.1121 32.1056 34.6926 -2.59197 2.17732 9.39736 -4941 6 19.2966 38.5284 11.8437 26.0429 16.0259 -0.414132 -4942 4 19.2747 37.5954 11.9891 -3.91225 -17.7096 3.53088 -4943 4 20.0654 38.8356 12.3915 -17.5462 -2.40166 -9.14392 -4944 6 6.53181 13.5016 26.8314 -26.032 48.4544 -13.2533 -4945 4 5.96734 14.0602 26.204 31.1233 -23.713 24.7575 -4946 4 6.50803 12.6321 26.4707 -0.853216 -24.803 -10.5103 -4947 6 23.5899 31.5666 33.3383 5.98922 -6.50638 -9.93577 -4948 4 23.0479 31.6137 34.1308 1.15429 -4.79335 1.92272 -4949 4 23.6428 30.629 33.0606 -7.31668 7.17491 0.194963 -4950 6 41.0566 31.9249 16.2102 56.5158 -30.8904 -22.4873 -4951 4 41.9283 32.0344 16.659 -25.525 5.07155 -0.752829 -4952 4 41.3339 31.2779 15.4895 -19.0587 21.5349 12.1439 -4953 6 31.7523 18.8667 19.3593 3.35741 25.414 0.712525 -4954 4 32.0759 19.7269 19.7383 -8.81617 -22.0304 -12.3923 -4955 4 31.2718 18.4298 20.0739 7.05067 -2.94537 3.38628 -4956 6 10.4941 4.11052 19.3414 6.42456 29.4713 -33.6332 -4957 4 9.72315 4.57262 18.9428 7.32966 -14.5804 7.11 -4958 4 11.2095 4.33965 18.6811 -15.5987 -11.1936 33.5314 -4959 6 1.36933 32.4682 19.2841 21.0988 -14.4161 24.2075 -4960 4 2.01529 31.7231 19.2122 -13.2253 9.85044 -10.2965 -4961 4 1.01532 32.721 18.4367 5.36339 -4.1954 -20.4987 -4962 6 42.8687 16.8583 24.9978 45.6636 -43.4462 -50.5941 -4963 4 42.5079 17.7172 24.9824 -17.3855 32.283 0.331695 -4964 4 43.4322 16.7911 24.1362 -30.0172 8.55702 44.8961 -4965 6 45.317 19.181 4.10785 3.8422 34.8536 -4.15721 -4966 4 46.019 19.8398 3.89275 -2.03222 -14.2005 10.5278 -4967 4 44.6424 19.7199 4.5744 3.59127 -10.0852 -3.22755 -4968 6 29.1417 19.8939 35.7514 6.11075 -32.58 -16.2332 -4969 4 28.6926 20.3067 36.4515 -23.9686 13.1333 31.3988 -4970 4 29.2427 20.5957 35.1143 7.28783 5.32225 -12.4577 -4971 6 31.9564 21.8498 19.6592 2.82401 14.2352 -0.350828 -4972 4 32.7548 21.9543 19.0677 -31.5105 -7.28354 24.2009 -4973 4 31.6217 22.7614 19.848 10.5207 -20.3739 -6.13763 -4974 6 39.1981 8.2717 18.8284 -32.9061 14.1933 0.428726 -4975 4 38.9624 7.35629 18.6463 1.07118 -6.83808 -1.96228 -4976 4 38.3348 8.76709 18.6863 31.0345 -14.9445 1.78619 -4977 6 33.2818 13.2775 41.2684 -13.2208 -33.3764 1.31987 -4978 4 32.393 13.5626 41.0006 -3.83673 2.91025 7.56978 -4979 4 33.1808 12.3338 41.5845 5.22215 22.8712 -2.04361 -4980 6 5.9413 29.5498 35.797 -32.456 -34.3071 -6.72563 -4981 4 6.35963 30.284 36.1739 22.861 33.0715 10.0739 -4982 4 6.49565 29.1835 35.1072 8.32337 2.91553 -5.44074 -4983 6 13.0321 34.2086 31.915 -24.835 -40.2345 36.8573 -4984 4 13.0272 33.4084 31.376 1.88868 -0.760633 -7.07942 -4985 4 12.5489 33.9041 32.737 18.271 18.5714 -18.1292 -4986 6 33.9591 21.7903 18.011 18.8454 -21.734 -8.71067 -4987 4 34.7458 21.1933 18.012 -16.5142 3.18134 2.17277 -4988 4 34.2934 22.6573 17.8484 16.983 20.6817 -10.003 -4989 6 35.9748 41.3385 18.1559 -11.3515 0.0380054 -35.3696 -4990 4 35.8093 41.5204 17.1769 9.12346 -12.4659 34.6458 -4991 4 36.6045 0.098617 18.3947 7.40652 10.177 5.52403 -4992 6 34.8515 37.6574 30.5934 11.7527 -35.7483 27.3047 -4993 4 35.1492 36.8608 30.1169 2.57906 15.2804 -10.7791 -4994 4 34.9371 37.33 31.5271 -8.43612 19.6249 -16.9201 -4995 6 26.002 34.4146 4.67279 -8.48904 3.78898 9.19231 -4996 4 25.4415 34.5852 5.42871 -16.9308 -4.98482 2.97274 -4997 4 26.7915 34.86 4.9592 18.7282 4.65341 -5.76761 -4998 6 19.0552 33.5605 1.32358 6.49267 31.5074 -37.6332 -4999 4 19.8139 33.1288 1.70335 8.38847 -12.1483 9.88993 -5000 4 19.4402 34.1326 0.589952 -11.7405 -21.1797 25.0755 -5001 6 25.2648 8.23393 8.59155 9.31521 -3.65292 19.8467 -5002 4 25.4875 8.13778 9.5404 -3.07709 1.08931 -10.3145 -5003 4 25.4314 9.16241 8.38927 -1.28134 -0.00667841 -6.07783 -5004 6 12.8479 19.6935 13.0483 24.3757 5.37981 -4.8091 -5005 4 11.9603 19.9957 12.9501 -28.6845 1.86907 1.18076 -5006 4 13.3523 20.516 12.8959 -4.89806 -16.374 -0.906345 -5007 6 53.3502 11.4299 5.80806 17.1624 -7.42289 17.7098 -5008 4 53.8461 12.0471 6.36061 9.49207 -4.93163 0.0376 -5009 4 52.6392 11.9481 5.49246 -25.6427 10.4986 -14.7278 -5010 6 9.84876 16.0411 31.2026 18.9205 20.8399 7.27663 -5011 4 9.06508 15.7062 30.7868 -18.8641 -2.54228 -13.3824 -5012 4 9.84527 17.0253 31.1624 -7.05614 -14.0763 0.861631 -5013 6 25.427 20.2931 3.30062 11.4464 23.222 26.9187 -5014 4 25.5454 20.7694 4.15249 -9.33169 -17.4988 -10.5652 -5015 4 25.6323 21.0333 2.7154 -3.32412 -15.1122 -12.6987 -5016 6 20.7611 8.20749 15.6389 12.285 -44.7943 -30.6071 -5017 4 20.4521 8.55687 16.4556 -20.4937 3.03897 24.5457 -5018 4 20.4185 7.27697 15.5079 3.31214 29.403 13.2982 -5019 6 37.6491 8.60321 9.97383 13.4411 2.14626 39.4708 -5020 4 37.9762 7.71523 10.2023 -7.3296 7.95364 -3.74733 -5021 4 37.281 8.55077 9.10696 -2.37522 -5.79058 -16.8845 -5022 6 50.6587 4.51935 24.2622 -13.5896 -19.0591 8.29097 -5023 4 49.9232 3.87067 24.2726 8.09814 12.5004 -4.89174 -5024 4 51.4381 3.99879 24.4754 4.23299 2.4676 7.18675 -5025 6 20.1738 24.8175 34.9087 -20.6162 39.8894 -22.5586 -5026 4 19.8889 25.4664 34.1955 11.6566 -19.5752 19.2833 -5027 4 20.4138 24.0094 34.4666 -0.241841 -16.354 -5.00311 -5028 6 30.5812 22.5243 11.2258 -36.8716 21.596 38.6978 -5029 4 31.1688 21.9929 10.7494 35.9784 -15.9007 -22.5785 -5030 4 31.0799 23.2498 11.6175 0.71333 3.79074 -7.65826 -5031 6 17.3246 40.781 8.03002 -31.7256 21.6985 11.3561 -5032 4 17.3609 40.073 8.69249 8.70624 -3.14378 -12.3263 -5033 4 18.1517 40.9293 7.58873 21.0517 -16.9909 -7.06703 -5034 6 23.9551 41.0422 26.0635 49.9815 4.82526 35.6353 -5035 4 24.3667 40.5978 25.3173 -4.54613 -3.84774 -13.2149 -5036 4 23.0402 41.1884 25.9461 -38.539 -4.36769 -14.447 -5037 6 9.79432 25.5848 27.2203 6.65484 -20.1236 -27.319 -5038 4 10.0774 24.9678 26.4912 -4.54744 21.2611 22.5851 -5039 4 10.2742 25.3181 28.0139 -2.97183 -5.43805 2.20583 -5040 6 35.2559 29.8148 24.7567 4.66903 26.9266 -5.93859 -5041 4 34.3843 29.755 24.359 -8.51564 -12.4096 -2.57191 -5042 4 35.4992 30.7322 24.5163 3.09853 -9.53322 8.65044 -5043 6 2.14554 4.24448 10.5593 -22.2482 14.7122 10.1934 -5044 4 1.71214 4.34677 11.4486 21.0071 -10.277 -13.7719 -5045 4 1.55235 4.73342 9.96914 3.10164 -3.012 2.95666 -5046 6 43.1737 3.93442 23.504 -19.8173 -22.9925 0.828755 -5047 4 43.8868 4.03822 22.8829 13.7397 8.75634 -8.56433 -5048 4 42.5624 3.30318 23.0634 7.12322 11.7882 3.68849 -5049 6 18.8936 22.6308 2.43475 37.4693 -11.6119 5.39147 -5050 4 19.8359 22.2985 2.41568 -31.8063 3.38645 -2.45846 -5051 4 18.7431 22.7947 3.37318 -4.67781 1.83629 -1.28906 -5052 6 20.5039 18.9394 41.5502 -45.0653 -1.00263 50.2155 -5053 4 20.0478 18.6838 0.506021 30.3651 -1.16827 -32.2456 -5054 4 19.9073 19.6506 41.2865 12.7012 -1.26976 -15.3796 -5055 6 26.407 7.54687 29.1121 1.4357 2.47637 1.41449 -5056 4 25.6724 7.10479 28.6297 19.9382 8.96422 9.98625 -5057 4 27.0918 7.77745 28.4582 -11.2115 -7.41118 6.83701 -5058 6 25.6474 35.5684 33.7551 28.3954 -27.4775 -24.9773 -5059 4 26.3573 36.1942 33.5448 -9.56627 7.56335 10.8035 -5060 4 25.9974 34.7724 33.2466 -29.6941 19.0168 23.1671 -5061 6 24.829 0.49304 8.41898 49.9168 25.8876 59 -5062 4 25.5758 0.370102 9.1289 -47.1903 5.46774 -40.7742 -5063 4 24.7798 41.5674 8.0141 -4.73142 -31.3088 -22.2887 -5064 6 17.0191 17.3177 3.44507 -46.3903 19.7373 51.2207 -5065 4 16.2469 17.9517 3.64762 33.8447 -23.651 -21.8207 -5066 4 17.1185 16.9245 4.35427 5.98982 5.76213 -27.3591 -5067 6 40.1787 32.0965 19.3495 -2.04197 44.459 1.39821 -5068 4 39.7315 31.3261 19.6693 2.08081 -28.8107 0.337304 -5069 4 40.9568 31.869 18.8472 6.84111 -19.9226 -1.15348 -5070 6 23.382 26.6945 6.30636 26.5913 52.1271 15.5788 -5071 4 24.0556 27.4456 6.44648 -17.1373 -33.2326 -1.34025 -5072 4 22.7142 27.1153 5.75328 -6.08389 -4.52619 -7.61988 -5073 6 28.6524 28.5085 1.41248 40.8971 -13.4399 -11.1281 -5074 4 28.8916 29.4207 1.30452 -22.1266 20.7664 -4.28256 -5075 4 29.5558 28.1704 1.18501 -32.1523 -8.03877 13.3744 -5076 6 12.0456 6.33448 14.0345 -15.8903 -34.4 -29.7535 -5077 4 11.2902 6.05291 13.4483 16.0844 18.9407 21.6686 -5078 4 12.7823 5.99392 13.4906 5.33453 16.7776 14.1371 -5079 6 20.1258 33.7078 32.0959 -18.1893 1.56867 -4.93457 -5080 4 20.1945 33.0222 32.7471 -6.29187 -8.74149 18.477 -5081 4 21.0272 33.8529 31.8657 20.6776 7.89431 -10.0095 -5082 6 12.0665 33.3691 34.5458 -17.2285 -56.0193 -22.1145 -5083 4 11.5086 33.8793 35.1106 -7.76206 16.4549 16.9315 -5084 4 11.5605 32.4987 34.4127 27.4292 33.0374 0.608769 -5085 6 6.00658 22.2666 25.0532 -19.3255 -5.39958 94.237 -5086 4 5.834 22.4197 24.1868 -9.01045 11.6196 -89.8037 -5087 4 5.17345 22.6031 25.4913 31.6285 -9.76338 -3.83253 -5088 6 28.8848 9.49767 11.035 16.7623 9.63116 22.4077 -5089 4 29.0495 10.2086 11.6768 10.1151 -22.3542 -11.392 -5090 4 28.083 9.83925 10.6889 -25.6685 -5.48517 -25.0151 -5091 6 25.9808 31.1499 24.8669 6.22835 -24.9986 7.12483 -5092 4 26.2942 31.9621 24.5011 4.31737 18.7644 -10.9339 -5093 4 26.6597 30.4768 24.6157 -18.0541 8.02771 8.13926 -5094 6 17.4051 22.6403 26.9653 -7.75883 36.9734 2.0054 -5095 4 17.2144 23.5004 27.4753 3.96627 -41.4428 -18.3441 -5096 4 17.5261 21.9375 27.6083 1.93016 -8.19761 6.25563 -5097 6 30.9714 17.6252 1.64088 21.0154 14.9482 37.3685 -5098 4 30.2059 17.6112 1.0839 -20.4324 5.80492 -14.3468 -5099 4 30.9516 18.4373 2.23396 3.22156 -25.7853 -22.8165 -5100 6 35.2764 9.72503 11.2414 -18.3895 -2.76749 -51.624 -5101 4 34.6551 9.56245 10.4589 20.7383 2.80865 37.1903 -5102 4 36.1302 9.43155 10.8742 2.68762 -2.05229 10.7544 -5103 6 12.0172 10.802 4.27563 -38.9121 -6.07101 -4.90761 -5104 4 11.4313 10.6374 5.04504 13.8247 1.49432 -7.40831 -5105 4 11.4074 10.5604 3.53263 22.811 5.33779 9.30002 -5106 6 52.9577 23.1313 7.67787 -9.3269 3.09364 -7.79077 -5107 4 53.8153 23.0871 7.22609 1.51949 2.98805 -1.25247 -5108 4 52.6879 24.0607 7.78743 10.5919 -6.87524 0.0783357 -5109 6 27.3762 5.80009 23.1013 37.771 37.8703 25.2466 -5110 4 28.2178 5.56094 23.5856 -32.2451 -1.57897 -13.9899 -5111 4 27.4704 6.79781 23.0764 -15.1432 -38.3322 -6.34326 -5112 6 22.7771 37.7063 15.5287 -6.89324 -10.2053 44.7861 -5113 4 22.8198 37.7465 14.5962 3.81902 5.91484 -35.4551 -5114 4 23.2903 36.9427 15.8415 -1.83068 2.7653 -4.67104 -5115 6 30.583 30.1381 39.7472 11.9278 5.78959 4.89923 -5116 4 30.1399 29.6129 39.0656 -4.27402 4.25284 -2.63349 -5117 4 30.6547 31.067 39.4612 -8.3831 -13.7724 -7.9353 -5118 6 26.5154 14.8633 29.9609 11.0831 -12.5589 -33.9006 -5119 4 25.6935 15.2477 30.2118 -18.1143 15.4408 19.147 -5120 4 27.1376 14.9035 30.6723 6.99544 5.71887 23.1856 -5121 6 9.52617 19.5446 37.4141 -27.8096 33.0225 -3.94279 -5122 4 8.56344 19.6819 37.5998 22.5694 -19.9005 4.13551 -5123 4 9.71087 20.3892 36.9619 8.68778 -16.8671 10.038 -5124 6 0.93064 14.8656 2.69338 -45.7679 -11.5139 71.6593 -5125 4 1.44105 15.217 2.01526 37.3122 25.2366 -40.5783 -5126 4 0.982855 15.4275 3.5214 11.2099 -15.0526 -29.9277 -5127 6 46.4291 27.1302 41.5927 44.8021 -5.11347 -18.4756 -5128 4 47.4269 27.1857 41.3316 -52.8753 -1.56841 10.8767 -5129 4 46.0453 26.5632 40.9031 3.09365 7.20255 7.14326 -5130 6 47.6703 23.0461 21.3817 14.1329 62.5249 18.4178 -5131 4 46.9615 23.2467 20.7836 -14.1781 -2.67912 -10.5965 -5132 4 47.8255 22.1376 21.4096 0.736735 -54.6337 -3.62162 -5133 6 39.861 22.2186 3.09273 14.3751 -13.6386 -17.8056 -5134 4 38.9812 22.2192 3.47284 -7.54245 -0.786418 6.90323 -5135 4 40.0217 21.2868 2.78929 -10.5756 29.8648 14.1337 -5136 6 14.9857 14.9315 33.4628 8.45923 30.4043 17.83 -5137 4 15.3946 15.8263 33.6275 -11.7248 -28.7506 -9.93609 -5138 4 14.5839 14.7058 34.318 1.67348 -1.86342 -8.89677 -5139 6 27.3225 11.4951 31.9326 -53.5602 -46.3542 13.457 -5140 4 26.8632 12.0627 32.5566 10.8872 8.4751 3.08438 -5141 4 28.1269 11.8297 31.6518 53.6341 36.944 -15.9306 -5142 6 36.7606 7.97817 7.63938 -5.6216 -14.483 -15.6739 -5143 4 35.961 7.43887 7.80711 8.78578 3.79539 -7.6162 -5144 4 37.414 7.37034 7.2323 -6.45073 3.96969 3.37374 -5145 6 49.4351 9.64395 18.2091 29.626 55.2849 10.866 -5146 4 50.1121 10.1978 17.7651 -9.80365 -29.4086 -13.348 -5147 4 49.2806 10.2909 18.9191 -22.4891 -21.6225 2.73598 -5148 6 27.0558 33.8708 10.7695 -35.2964 21.4972 9.63291 -5149 4 27.0077 33.3399 10.0051 13.5655 -23.8621 -34.587 -5150 4 26.1863 34.3133 10.6733 10.9844 1.63438 18.9088 -5151 6 11.1931 37.467 6.82672 4.88099 -16.6436 19.1561 -5152 4 10.8369 38.341 6.72067 -6.30082 13.8936 -5.38019 -5153 4 12.1372 37.6177 6.93955 5.33816 -5.06614 -4.03667 -5154 6 19.2682 19.4041 21.904 -23.2853 8.1035 46.9014 -5155 4 18.5523 19.4276 21.2977 -21.2798 -5.04156 -20.5384 -5156 4 20.0545 19.4439 21.4012 35.6905 -5.22778 -21.4405 -5157 6 54.5004 2.91828 22.5705 32.5661 -1.01917 48.733 -5158 4 54.2618 3.02388 21.6728 -2.16971 10.501 -40.9175 -5159 4 0.435524 3.25313 22.7695 -30.9494 -6.38648 -13.13 -5160 6 45.0599 10.868 24.2364 14.5135 -18.2796 4.13426 -5161 4 44.3635 11.4663 23.9664 0.226806 13.7258 12.1538 -5162 4 45.5813 11.1999 25.0017 -10.9868 0.331296 -15.4884 -5163 6 14.3917 34.4176 24.7766 -9.76404 -18.453 -6.38428 -5164 4 14.7761 35.2693 24.9957 4.99605 2.44674 1.2141 -5165 4 14.8449 34.0832 23.9904 0.575187 7.45256 -7.27956 -5166 6 50.5869 17.5623 4.30497 19.1488 -58.6727 24.3661 -5167 4 51.3501 17.8958 4.78847 0.670503 12.5806 -1.04554 -5168 4 50.1422 18.2474 3.88142 -19.7161 48.0777 -23.3625 -5169 6 14.9242 33.337 34.1076 -18.6172 33.5363 80.554 -5170 4 15.0808 32.9083 33.3321 11.226 -38.5345 -73.3592 -5171 4 14.0723 33.0217 34.4665 7.96171 10.4343 -9.42002 -5172 6 20.8631 33.5747 38.9135 21.2953 11.2024 -25.7312 -5173 4 20.865 34.0752 39.7143 -3.94121 7.45437 24.6588 -5174 4 20.36 32.7884 39.0656 -12.436 -21.6406 1.81461 -5175 6 7.7707 4.74963 26.7362 26.5342 -10.6541 19.1955 -5176 4 7.23261 4.91898 27.5026 -6.83786 10.9421 8.37469 -5177 4 7.15089 4.73593 26.0203 -3.95236 1.60233 -15.9617 -5178 6 9.2875 21.4887 22.2941 45.0197 -19.5209 20.7118 -5179 4 8.6739 21.9912 21.7696 -4.21454 15.1903 -23.2464 -5180 4 10.2572 21.6206 22.0058 -46.5259 5.6334 -2.177 -5181 6 20.5439 38.2154 8.85856 -11.8412 3.64647 49.7312 -5182 4 20.3505 38.5634 9.79035 9.75602 -4.66312 -40.2998 -5183 4 20.2844 37.2891 8.95048 10.2824 2.6457 -7.05014 -5184 6 30.1005 39.0839 30.7484 -12.1958 38.1552 23.9792 -5185 4 30.3724 39.9578 31.2326 -12.541 -45.9124 -25.2432 -5186 4 29.1103 39.003 30.8437 30.6219 6.07536 -1.13857 -5187 6 16.0462 22.036 24.5064 2.37861 -9.55962 -5.99251 -5188 4 16.6334 21.9741 23.7207 6.17482 7.89117 19.2285 -5189 4 16.5569 22.3155 25.2979 1.4399 -2.17025 -8.02685 -5190 6 5.74172 29.2061 14.4603 -14.7312 11.1013 -1.58992 -5191 4 6.41865 28.6839 14.8489 24.8954 -16.4528 0.429681 -5192 4 5.37542 29.618 15.2515 -13.4536 5.99623 -6.25212 -5193 6 28.0689 3.08071 25.2267 -3.20814 35.3244 14.901 -5194 4 28.6407 3.76435 24.8336 -2.36389 -14.401 -4.10269 -5195 4 27.6795 3.6106 25.9691 7.41152 -23.0621 -10.2478 -5196 6 45.9381 29.3111 31.4283 -35.5447 25.9568 9.82539 -5197 4 45.677 28.707 30.7493 2.31008 -18.1922 -21.3643 -5198 4 45.1265 29.9079 31.4744 34.4717 -15.8255 11.1052 -5199 6 11.2229 22.8376 36.7897 -1.27591 2.9175 -5.69903 -5200 4 10.6623 23.4314 36.25 10.4728 -5.78036 -0.0474996 -5201 4 12.0147 22.5841 36.2713 -9.37786 4.28983 5.66853 -5202 6 18.9444 40.1485 39.92 -15.471 -8.01044 2.33142 -5203 4 19.1439 39.1941 39.9507 -1.34087 5.25319 4.4419 -5204 4 18.8847 40.4877 40.8271 3.43659 -8.21326 1.76593 -5205 6 23.5503 26.0803 21.2869 1.98517 -8.46863 16.2364 -5206 4 22.847 26.649 20.9475 -0.393515 -5.32061 4.06564 -5207 4 23.2913 25.6403 22.1336 -2.29953 13.2014 -21.5927 -5208 6 16.8518 5.38834 15.8565 -25.8193 5.07215 -6.0744 -5209 4 16.3979 5.3834 15.0179 8.08064 -16.6857 -11.3384 -5210 4 16.3642 6.13153 16.2159 17.5374 8.90145 23.838 -5211 6 12.0293 26.6115 15.0052 48.8575 28.3431 -20.5386 -5212 4 11.753 25.9113 15.557 -22.1508 -25.2102 16.954 -5213 4 11.3677 26.9943 14.4309 -20.7091 -9.23994 -0.184726 -5214 6 14.3404 41.4231 2.37222 21.8802 31.2536 -15.2067 -5215 4 13.6639 41.0433 2.88545 -29.1815 -25.4177 23.2655 -5216 4 14.3137 0.446574 2.65591 6.04323 -12.5169 -2.89291 -5217 6 50.3994 35.8721 9.32148 7.74023 -5.00078 -0.0244409 -5218 4 50.7985 35.7097 8.44539 1.7624 12.9821 5.72804 -5219 4 50.9327 36.5364 9.8137 -9.76519 -8.88391 -14.7497 -5220 6 11.3732 22.6657 26.8674 13.5542 4.36995 9.37334 -5221 4 12.2226 22.4007 26.49 -3.86507 -2.48494 3.34128 -5222 4 10.7274 22.4174 26.2153 -14.8849 -5.84603 -9.40936 -5223 6 8.44501 34.5567 21.2657 -4.1178 -59.9386 7.63204 -5224 4 8.06567 35.1301 21.9247 -8.42944 2.78434 16.8569 -5225 4 8.10966 33.58 21.4462 13.1168 58.8803 -11.2866 -5226 6 9.4289 8.66253 24.4817 -31.3326 14.2813 -20.5935 -5227 4 8.45611 8.64572 24.2655 24.8039 10.7682 6.42659 -5228 4 9.52915 9.21836 25.2644 -0.461641 7.68001 5.20174 -5229 6 32.603 22.3274 34.5057 1.1064 -2.38466 -37.2003 -5230 4 32.4525 23.1707 34.0368 4.85154 -2.46017 7.68642 -5231 4 32.8396 22.5701 35.3818 7.58742 14.9461 32.9529 -5232 6 26.736 26.1837 7.12165 10.4716 16.8024 -17.1295 -5233 4 25.9537 25.8031 7.51207 -7.84415 -15.2109 12.7352 -5234 4 26.4604 27.1054 6.93432 8.77765 -19.2484 4.4957 -5235 6 34.0014 11.9295 3.96807 -3.56186 4.82634 5.33773 -5236 4 33.6494 11.5631 4.78494 7.3544 2.33703 4.85457 -5237 4 33.8594 12.8842 4.06904 0.478869 -2.08104 -5.13073 -5238 6 21.473 20.924 37.1992 5.8677 19.4674 12.3893 -5239 4 22.3242 21.3752 37.157 2.6693 1.87465 3.04951 -5240 4 21.708 20.0203 37.0255 -6.20277 -25.1527 -1.47337 -5241 6 18.4792 41.0219 0.672743 -35.2491 -25.3697 -26.4792 -5242 4 17.5363 41.1592 0.451811 6.2729 -6.09178 6.10687 -5243 4 18.7532 41.8934 0.847545 18.5165 37.9853 8.81983 -5244 6 41.3458 41.7141 25.1818 17.8335 14.8146 -1.57438 -5245 4 40.8444 40.9381 25.3951 -6.7286 -20.9895 5.67055 -5246 4 41.5773 41.6158 24.2546 -2.61686 2.51709 -2.2804 -5247 6 27.6337 28.128 3.93443 68.2433 49.922 -72.4808 -5248 4 27.747 28.0641 2.90056 -5.60951 6.59214 55.905 -5249 4 26.974 27.5707 4.19301 -60.7891 -51.6503 16.466 -5250 6 18.2766 10.5218 31.4985 31.6557 -13.945 -4.11948 -5251 4 17.4661 10.038 31.5755 -21.8827 2.32902 1.26527 -5252 4 18.1351 11.463 31.4681 -8.30794 8.79106 3.21692 -5253 6 11.3047 37.9513 14.7719 14.2766 22.5792 8.51892 -5254 4 10.8196 37.2524 14.3384 -3.55752 -10.2024 4.33151 -5255 4 11.8722 37.607 15.4977 -19.1201 -2.12261 -16.4117 -5256 6 0.810718 18.1323 27.5767 30.9572 19.3393 -0.702274 -5257 4 0.190255 17.4711 27.3024 -13.6082 -17.9307 4.12615 -5258 4 1.6652 17.6816 27.7433 -15.3641 2.36995 -0.952151 -5259 6 36.7957 10.7342 20.2882 16.9593 17.0847 7.18326 -5260 4 36.2525 10.0089 20.0111 -13.8544 -11.0907 -5.31633 -5261 4 36.5766 10.8708 21.2175 -0.466777 -2.92115 4.06643 -5262 6 47.4269 25.5204 8.035 -8.77625 7.04012 -26.0141 -5263 4 47.2351 25.672 7.07342 16.0738 -5.10236 26.6147 -5264 4 46.6031 25.1946 8.38488 -7.38433 -0.0309169 8.21918 -5265 6 13.9121 35.1279 15.9963 57.6206 21.904 15.8158 -5266 4 13.18 34.6338 16.2776 -41.6081 -30.4219 4.97616 -5267 4 13.8612 35.4714 15.1124 -11.7278 3.29634 -19.5683 -5268 6 29.56 35.3617 16.1847 -46.2751 8.28104 -14.7299 -5269 4 30.2098 34.9035 16.6971 16.3841 -9.08849 15.1595 -5270 4 28.6495 34.9755 16.3324 34.0842 8.73794 -6.93478 -5271 6 29.4892 25.8842 32.4194 -24.256 -10.4352 -29.1805 -5272 4 28.8256 25.7516 33.0892 -1.91161 2.59937 23.0953 -5273 4 29.0388 25.4531 31.6468 24.6149 5.96309 7.68736 -5274 6 24.1242 2.12171 25.4449 33.2745 25.8541 -21.7468 -5275 4 24.4973 2.84525 24.8288 -6.14236 -31.0627 26.9036 -5276 4 24.7925 1.39916 25.5361 -16.9688 12.032 -10.1501 -5277 6 4.54733 34.4389 19.1463 -35.302 -7.10976 -3.39284 -5278 4 4.35486 34.5879 18.2161 16.9971 0.874352 -7.12679 -5279 4 3.63202 34.4395 19.5005 25.743 -3.14875 11.9651 -5280 6 10.1206 17.2361 14.3164 8.36708 -29.6599 -28.3251 -5281 4 10.306 17.5039 15.1955 -0.106022 16.7729 24.4966 -5282 4 9.5035 17.8022 13.8616 -7.59249 10.3925 2.01091 -5283 6 21.4437 41.7724 34.6698 -12.6382 -8.67476 11.1219 -5284 4 21.3209 41.1297 35.367 19.1323 -10.7035 11.8578 -5285 4 20.52 0.052046 34.4982 -0.738196 4.11389 -17.598 -5286 6 36.1618 24.1149 12.6039 -38.5184 -29.276 -18.6614 -5287 4 35.5274 23.7914 13.2897 25.4622 4.78071 -2.2183 -5288 4 35.751 23.7447 11.7708 17.6549 15.9976 15.8112 -5289 6 49.5813 18.6026 19.9424 19.3655 4.31785 -3.79274 -5290 4 50.05 19.3681 19.5461 -11.4841 -9.87428 2.01803 -5291 4 50.2881 17.9408 20.0283 -8.44417 3.53865 1.64593 -5292 6 1.24663 7.05846 14.4912 39.2605 -25.8072 -27.0237 -5293 4 1.83321 6.85564 13.6734 -27.5618 7.792 37.3713 -5294 4 1.40902 6.33035 15.1313 0.69425 14.6008 -10.3474 -5295 6 12.7431 22.7725 31.2519 -28.0711 -22.2846 -24.537 -5296 4 12.731 22.0484 30.5842 -1.03989 14.4355 17.1556 -5297 4 13.6361 23.0601 31.2889 29.0982 7.61123 0.941905 -5298 6 8.17623 18.6217 27.8167 28.4831 -7.95646 -20.137 -5299 4 8.40342 17.6669 27.8028 -7.19499 14.8132 8.92302 -5300 4 8.90402 18.9943 27.2753 -13.5351 -1.9306 8.34595 -5301 6 52.1398 28.0368 15.3061 -5.99984 -2.63203 -6.56281 -5302 4 52.212 27.4921 14.5152 3.50742 -7.1981 5.43712 -5303 4 52.1344 28.9249 14.9274 -1.52971 -5.17654 6.68842 -5304 6 52.6974 21.8977 10.081 -19.9085 6.90605 5.3514 -5305 4 53.3388 22.3376 10.626 19.2735 6.64212 5.60719 -5306 4 52.8023 22.3165 9.21858 0.448532 -1.39229 -3.54893 -5307 6 22.3312 5.79987 2.67028 14.2956 -6.96789 22.7666 -5308 4 22.4342 5.66665 3.62826 -7.95027 2.50856 -4.24886 -5309 4 22.7763 5.02131 2.34757 -2.68692 -18.1597 -17.0707 -5310 6 15.4178 16.2178 21.8878 29.1139 16.3559 -34.9346 -5311 4 14.4763 16.1482 22.0206 -17.0561 3.51129 1.66656 -5312 4 15.5967 16.6295 20.979 -16.1676 -12.6325 35.129 -5313 6 28.6996 41.2944 33.8986 -0.299799 0.972013 4.01662 -5314 4 28.6528 40.5712 34.5346 5.69191 -6.81028 -1.89437 -5315 4 27.7925 41.4039 33.5788 7.00998 2.71453 4.16387 -5316 6 9.0271 31.2603 18.2166 -24.0632 3.5617 9.69965 -5317 4 9.00312 32.2249 18.3215 -0.833429 -0.795431 1.49639 -5318 4 8.39564 30.8695 18.8792 23.5138 4.17381 -14.686 -5319 6 20.5401 20.4009 18.1765 -9.82111 13.5354 -7.0052 -5320 4 21.0961 20.6619 18.9088 6.00228 -1.57494 14.3732 -5321 4 19.8969 21.1451 18.1138 9.42471 -20.4088 -2.28899 -5322 6 53.9632 14.7108 37.8185 38.9936 -13.777 37.4998 -5323 4 53.5065 15.4999 38.0588 -19.2143 21.2037 -5.62994 -5324 4 53.6553 14.2856 37.0504 -18.643 -5.89619 -29.3657 -5325 6 28.9005 15.3805 18.8553 43.4355 2.75939 -10.7082 -5326 4 29.8744 15.2601 18.5577 -43.1698 -4.30042 15.6378 -5327 4 28.8821 15.3937 19.8257 1.95554 -2.72042 -0.550014 -5328 6 2.00757 25.8231 18.9102 1.56834 13.1457 16.4238 -5329 4 2.16994 26.6099 18.3718 5.10623 3.14141 1.15535 -5330 4 1.76535 25.1325 18.3092 -5.75322 -15.1157 -18.9078 -5331 6 53.2586 40.7003 24.294 -3.95682 23.2035 5.10337 -5332 4 53.3627 39.7881 24.0333 10.577 -13.1769 -1.30533 -5333 4 54.0929 41.151 24.0537 -8.8009 -7.19084 1.91562 -5334 6 47.531 32.0044 22.8424 -9.22212 4.73076 14.8806 -5335 4 47.3777 32.6735 23.5302 -5.63931 6.65432 -9.88941 -5336 4 48.2144 31.4763 23.2497 9.41484 -5.26157 -3.09765 -5337 6 24.6289 26.1478 33.0175 -22.0968 -9.02062 -12.6011 -5338 4 24.4656 25.5474 33.7557 -1.10221 8.12594 5.97613 -5339 4 25.4283 26.6445 33.1202 14.9272 4.196 4.65224 -5340 6 21.3417 17.0876 39.4763 -6.70912 6.89414 0.748051 -5341 4 22.0272 16.5901 39.8927 14.9242 -9.38388 2.18929 -5342 4 20.9728 17.5957 40.2063 -4.43123 6.71259 -1.60026 -5343 6 11.0417 40.4515 17.0271 -4.84825 -47.9733 -31.3307 -5344 4 11.617 41.1325 17.3235 21.4854 16.9952 0.793724 -5345 4 11.529 39.8797 16.3454 -22.439 27.66 32.3414 -5346 6 20.3522 21.2696 39.8718 -25.2322 13.8952 23.2629 -5347 4 20.7065 20.9823 39.0558 13.3567 -12.8249 -34.1322 -5348 4 21.0787 21.2544 40.4999 1.2931 1.07094 1.93889 -5349 6 2.11891 29.6947 22.5962 -10.9271 -4.15175 -1.48688 -5350 4 1.41229 29.0196 22.6861 11.0269 1.69063 -12.8134 -5351 4 2.97173 29.2673 22.4434 -6.16143 -1.40449 -3.11444 -5352 6 36.756 30.301 35.4561 22.3149 -30.6991 6.56967 -5353 4 36.1659 29.9908 36.1617 3.98829 10.9575 -2.82389 -5354 4 37.5905 29.761 35.5884 -25.1141 24.4323 0.251817 -5355 6 12.9563 4.31922 37.9158 -41.9162 -7.49401 17.923 -5356 4 12.213 3.67486 38.0016 27.2031 5.98064 4.05536 -5357 4 12.5797 5.11915 38.3509 20.8388 -3.72048 -10.4757 -5358 6 38.3368 5.25882 18.4553 -27.9454 13.7946 -11.1943 -5359 4 37.494 5.12162 18.8921 -4.17763 4.09508 -3.9191 -5360 4 38.9486 5.03087 19.1262 32.9808 -9.34357 19.7422 -5361 6 10.4991 9.23341 21.7308 -20.3579 1.12747 21.1104 -5362 4 10.1476 9.35811 22.629 -2.53412 -6.58654 -7.03761 -5363 4 11.4429 9.27697 21.8681 13.0367 -0.194449 -11.5952 -5364 6 0.510441 41.039 17.3204 -22.411 45.8537 -1.19125 -5365 4 1.10275 40.3438 17.515 21.9532 -27.5034 12.6219 -5366 4 0.955429 41.8901 17.5577 -0.403404 -22.4144 -8.21181 -5367 6 4.11028 5.06714 6.43108 -32.0559 -10.673 -25.0156 -5368 4 4.76196 4.43778 6.68194 21.2279 -22.0503 -6.17775 -5369 4 4.3376 5.79555 6.94869 8.69612 42.0455 26.6358 -5370 6 11.4527 25.4042 0.173069 -8.87291 20.1751 -4.43043 -5371 4 11.3037 26.302 0.51034 -2.48968 -2.12098 1.34892 -5372 4 12.3912 25.256 0.330533 -7.09022 -12.0676 2.67745 -5373 6 7.43008 21.5598 8.10589 6.84767 -16.7382 -30.018 -5374 4 7.67559 21.2373 7.18738 -12.1375 12.6211 33.8068 -5375 4 8.24892 21.8626 8.52003 -6.07298 -1.72571 -6.46698 -5376 6 47.5896 16.3642 25.2431 -28.5582 13.6976 -25.6498 -5377 4 46.6075 16.1608 25.1822 37.2389 5.55574 -4.66364 -5378 4 47.8562 16.8152 24.3682 -3.16196 -14.4146 40.515 -5379 6 30.9292 19.5125 39.8483 -41.4217 8.94898 -20.4144 -5380 4 31.859 19.4188 40.0164 22.9308 8.40553 1.58818 -5381 4 30.7224 20.3633 39.3589 16.5857 -27.3682 15.8932 -5382 6 20.3871 24.0387 39.4036 8.00795 23.2793 -8.75093 -5383 4 19.459 24.1701 39.2693 -20.2994 13.2523 2.58474 -5384 4 20.4244 23.1071 39.4874 5.50164 -36.2952 5.14995 -5385 6 45.8871 21.2471 41.1655 20.5283 25.7578 0.477301 -5386 4 46.6385 21.2626 41.7552 1.12624 -15.6366 20.1575 -5387 4 46.1812 21.9667 40.5962 -14.858 0.0662744 -14.6758 -5388 6 32.5732 28.1983 30.4559 17.8923 -19.7368 14.2663 -5389 4 32.9661 27.3096 30.6426 -14.7491 22.8943 -8.37245 -5390 4 33.2232 28.8091 30.8453 -8.57676 -1.81844 -4.53088 -5391 6 18.0207 1.32021 27.0363 -34.7874 1.53884 20.0911 -5392 4 17.0721 1.60205 27.1202 27.3864 -5.2263 -11.315 -5393 4 18.3294 1.50373 27.9381 11.4124 1.84961 -11.8648 -5394 6 39.378 24.9761 21.8758 -21.83 -3.15726 3.51608 -5395 4 39.2925 25.9351 21.9975 13.0773 -1.30024 -1.60914 -5396 4 38.5262 24.6687 22.2439 10.6836 3.42961 -4.87158 -5397 6 33.5904 21.3057 22.0908 0.876878 23.3779 1.34154 -5398 4 32.7037 21.4589 21.7601 -6.64994 -10.6299 -4.35651 -5399 4 34.0298 22.1428 21.8479 4.87062 -13.8873 3.79153 -5400 6 40.1162 15.0006 15.7553 -16.7667 -72.1851 -56.1125 -5401 4 39.3246 14.5665 15.2764 38.6699 22.9899 20.5541 -5402 4 39.7685 15.7046 16.224 -23.0828 51.553 35.6364 -5403 6 32.7063 17.9241 6.36312 -6.65812 28.0098 -27.693 -5404 4 32.6631 17.3286 7.08836 -4.96405 -26.2659 23.6138 -5405 4 32.2202 17.5402 5.61621 0.349997 -9.22032 2.43078 -5406 6 50.4717 15.9308 31.1336 -57.0185 -34.1342 43.3708 -5407 4 51.2677 16.1483 30.7347 55.5832 16.4654 -29.6643 -5408 4 50.5499 15.0059 31.4683 -2.42192 20.1529 -11.8828 -5409 6 23.8292 29.3322 31.6407 10.3974 -8.56959 5.42825 -5410 4 23.7096 29.6981 30.7618 4.3803 -0.813234 -2.10966 -5411 4 24.6813 28.8378 31.6594 -15.3785 13.3689 -4.34977 -5412 6 25.0524 41.6477 38.2806 4.00174 7.46449 -31.3583 -5413 4 25.6511 41.367 37.5454 -10.3054 -0.491554 23.0497 -5414 4 24.5276 0.474703 37.8884 8.98972 -6.87862 14.9811 -5415 6 14.3299 25.4693 7.99598 -51.8246 -23.5651 26.6357 -5416 4 15.0301 25.7523 7.4663 39.147 18.3395 -31.3738 -5417 4 13.6749 25.0466 7.38907 19.2382 9.49844 7.52052 -5418 6 17.2117 20.7467 5.34291 -12.6959 30.9635 29.5807 -5419 4 17.5658 20.2645 4.6512 13.3362 -42.6322 -45.6451 -5420 4 17.6752 21.5763 5.21476 -4.76461 12.1014 12.8322 -5421 6 18.8578 10.961 23.7113 11.9098 -52.6755 14.4862 -5422 4 18.5821 10.3312 23.0139 -2.7304 18.9854 0.947207 -5423 4 18.7069 11.8432 23.4586 -8.32501 34.3086 -18.4054 -5424 6 7.80658 41.3805 11.0401 -9.04392 11.0606 6.15122 -5425 4 8.00429 40.5098 11.4059 2.67644 4.01258 -4.23655 -5426 4 8.51691 0.066 11.3394 -1.81513 -7.16892 -1.05394 -5427 6 48.6966 23.1832 34.0648 -27.3561 -6.76338 -18.0805 -5428 4 48.0792 22.9132 33.32 19.6766 11.2437 24.8207 -5429 4 49.5669 23.23 33.6693 11.2336 0.854645 -6.12438 -5430 6 53.7246 23.5588 15.3422 -2.2993 4.88061 -38.5045 -5431 4 54.0115 23.9686 14.4981 1.04624 9.96871 20.6807 -5432 4 53.2132 22.8493 14.9574 -7.54922 -9.79714 16.7607 -5433 6 22.2409 5.63035 9.83732 -4.74687 0.990813 -28.4051 -5434 4 21.8007 4.9012 9.36518 5.41421 2.33681 17.3637 -5435 4 22.5704 6.16354 9.07597 -3.08255 -9.23766 25.1176 -5436 6 33.6677 8.38805 9.07277 4.65141 2.45263 2.68713 -5437 4 32.9476 8.96499 9.32099 -11.143 10.7473 10.4723 -5438 4 33.4213 8.08448 8.2012 2.38155 -0.0587928 -10.5973 -5439 6 47.3188 37.7205 20.3441 15.215 11.7573 -25.0114 -5440 4 47.5704 37.5879 19.4187 8.2864 3.06637 8.88956 -5441 4 46.6261 37.0853 20.3703 -21.7602 -22.9037 19.9419 -5442 6 30.8605 16.7391 10.6102 -28.0995 -48.2853 23.2284 -5443 4 30.4428 17.1675 11.4048 8.00556 -5.70758 -17.8294 -5444 4 30.5213 15.7576 10.5828 6.17084 54.1408 -3.58748 -5445 6 48.1227 27.723 10.1192 -17.271 38.6552 19.8549 -5446 4 48.941 27.5885 10.6019 15.4404 -6.10886 -7.64033 -5447 4 47.9667 27.1056 9.42146 1.69339 -23.2576 -13.9441 -5448 6 27.3465 38.6397 25.5972 -19.3603 -43.7567 25.3821 -5449 4 28.2552 38.3171 25.6348 3.73027 6.4174 -6.06634 -5450 4 27.3175 39.4354 25.1025 9.7616 28.5552 -11.1584 -5451 6 33.3485 5.72785 21.4502 -30.5322 15.1217 -10.2054 -5452 4 32.7106 6.21453 20.8566 24.3968 -18.0484 15.2917 -5453 4 34.2142 6.02589 21.2258 21.3261 10.3595 -12.9949 -5454 6 25.3097 5.14436 4.52462 -12.6707 -6.42781 10.7366 -5455 4 25.8166 5.03621 5.34324 9.24373 -0.000563512 -7.52253 -5456 4 24.4109 4.89546 4.80865 9.45245 1.955 -8.20101 -5457 6 40.4804 35.6472 19.1595 -4.18239 -17.2552 -25.1441 -5458 4 40.6473 35.1871 19.989 -0.677015 6.66802 10.9293 -5459 4 40.3876 36.5867 19.2889 2.08163 9.85771 9.62751 -5460 6 49.6466 30.6357 19.0258 14.8172 21.4531 -43.5404 -5461 4 50.0494 29.991 18.4245 -6.82309 -11.6442 2.45506 -5462 4 49.4912 30.1943 19.8303 -8.11919 -24.8089 39.0949 -5463 6 42.1414 28.3198 17.0336 30.9261 -8.96587 16.5499 -5464 4 41.9014 28.1134 16.1233 0.612516 -1.09878 -6.61247 -5465 4 42.9986 27.8356 17.2327 -32.0588 11.6021 -17.9905 -5466 6 47.7009 24.529 36.3602 12.6164 -10.6945 -29.4467 -5467 4 46.9511 23.9476 36.4057 -12.614 -6.01445 14.1932 -5468 4 48.02 24.3175 35.4647 6.89481 1.31964 6.68358 -5469 6 19.3487 26.9773 19.8132 -7.91098 29.1703 -3.69101 -5470 4 19.5772 26.0513 19.7652 -2.42994 -17.6971 2.90599 -5471 4 18.7132 27.1892 20.5145 5.94626 -13.5516 -3.80193 -5472 6 47.0594 26.8038 37.5124 29.171 -27.35 55.5912 -5473 4 46.5442 27.3901 37.0243 -28.7601 35.2651 -40.4696 -5474 4 47.4575 26.1126 36.9775 -8.83233 1.8809 -11.4479 -5475 6 9.306 24.6801 40.2841 31.4937 0.109789 0.329283 -5476 4 9.78189 23.9102 39.8717 -14.0424 16.7407 17.3327 -5477 4 10.0272 25.2082 40.7306 -19.6308 -16.1327 -14.1874 -5478 6 14.4855 17.9139 14.2735 23.8217 -2.3356 -5.96097 -5479 4 13.7756 18.1909 13.6871 -0.445295 3.10639 3.20472 -5480 4 15.2926 17.8532 13.6969 -24.9099 1.36359 15.4275 -5481 6 37.1333 38.6708 18.7289 9.24178 15.507 -32.6939 -5482 4 36.7257 39.5382 18.5851 -4.02817 -0.227247 6.07181 -5483 4 37.6697 38.5833 17.9067 -2.91955 -11.3843 16.172 -5484 6 11.4153 5.92336 21.4477 15.4675 -15.5323 24.3843 -5485 4 12.0347 5.46444 22.0611 -14.8481 11.1792 -11.8992 -5486 4 10.9828 5.22117 20.955 -5.02219 -4.37746 -7.57367 -5487 6 4.24672 30.7112 16.2271 25.0754 -37.7862 10.5022 -5488 4 4.05441 31.4608 15.7204 -4.71706 34.9582 -31.1175 -5489 4 3.72964 30.8334 16.9988 -11.892 -2.06994 24.4228 -5490 6 17.6689 16.0105 27.0706 -11.532 -19.4613 -16.5334 -5491 4 17.475 15.0322 27.0999 0.550485 29.0366 -12.0979 -5492 4 17.2014 16.3875 26.2691 10.8221 -16.0252 20.0561 -5493 6 36.4979 8.6445 40.4253 22.1182 5.90925 -1.87084 -5494 4 36.6649 9.56092 40.6574 -3.64727 2.10984 0.486612 -5495 4 35.6642 8.36755 40.7885 -12.5441 -1.64485 2.44437 -5496 6 13.6104 12.9476 3.01337 -0.796658 -1.76047 52.4558 -5497 4 13.281 12.534 3.85665 2.0295 3.09436 -35.1239 -5498 4 14.3672 13.4568 3.35498 1.79634 -1.71495 -16.7359 -5499 6 38.5663 20.1511 21.6276 16.2684 -2.59448 10.3838 -5500 4 39.225 20.3435 20.957 3.66548 0.723189 -1.42015 -5501 4 37.7399 20.1987 21.178 -26.4348 -4.9091 -11.1397 -5502 6 51.0002 10.2707 30.836 -20.0759 -41.5967 21.7358 -5503 4 51.4945 11.0341 30.626 15.2265 30.1997 -10.6067 -5504 4 50.365 10.1656 30.1217 2.42758 1.75416 -9.76943 -5505 6 16.2768 2.44039 41.3342 24.5898 23.894 -47.9169 -5506 4 15.7659 1.68969 41.4668 -26.4768 -52.1654 31.458 -5507 4 16.2309 2.46185 40.3616 9.12406 8.41144 7.6857 -5508 6 16.5823 4.96192 41.8916 -4.82165 52.2801 -70.6027 -5509 4 16.7504 4.9538 0.881833 10.2709 -3.72182 62.3109 -5510 4 16.3825 4.09214 41.6138 -6.48385 -26.7637 5.90228 -5511 6 38.2132 37.6512 20.9834 35.6931 -0.0015793 9.16781 -5512 4 38.1132 38.2158 20.1985 1.71026 -5.63736 5.42755 -5513 4 39.175 37.679 21.2752 -35.8773 5.52261 -11.9395 -5514 6 27.3063 1.90932 15.7743 -36.1781 7.04456 22.02 -5515 4 27.5288 1.21363 15.1745 3.62804 -9.29946 -19.0329 -5516 4 26.3092 1.89423 15.8276 27.8398 0.929522 -3.41863 -5517 6 29.0129 12.4346 37.8081 29.6396 -2.3639 23.3235 -5518 4 29.5703 13.228 37.8521 -9.25731 3.38449 -11.2245 -5519 4 29.432 11.8866 38.5178 -20.735 6.92768 -10.3763 -5520 6 46.0725 20.1624 18.9069 6.39102 14.9163 -14.6323 -5521 4 45.1723 20.516 18.8892 1.91785 -0.379773 0.405435 -5522 4 46.587 20.7656 18.3221 -3.54001 -13.7442 9.74416 -5523 6 2.03634 38.6845 18.4933 3.82981 -3.85695 21.6638 -5524 4 2.81563 38.6864 19.0472 23.4807 10.2435 -12.678 -5525 4 1.45125 38.3557 19.1766 -27.1945 -1.99387 -8.3623 -5526 6 44.0469 24.9707 25.966 7.80173 10.6441 20.9452 -5527 4 44.2747 24.0363 26.0952 1.37736 2.33249 -4.33209 -5528 4 43.5784 25.0701 25.1359 -3.49858 -7.6437 -6.59112 -5529 6 5.98346 26.6137 4.53144 23.0758 4.04073 24.4329 -5530 4 6.55391 27.1627 5.13089 -15.1794 -12.3526 -15.6845 -5531 4 6.29729 25.6938 4.67268 -13.7287 18.2257 -9.78447 -5532 6 0.087877 23.2081 10.934 24.9145 3.46447 1.10559 -5533 4 0.685292 23.7315 10.3726 -8.08066 -2.01306 3.92681 -5534 4 0.721975 22.7627 11.5282 -19.4067 -0.934622 -1.78644 -5535 6 39.1228 20.6282 12.8796 23.5823 -4.01912 3.74068 -5536 4 40.0483 20.9095 13.1274 -25.2182 -11.8294 -4.75086 -5537 4 38.9288 21.0058 12.0111 3.51405 8.21934 1.48951 -5538 6 39.9585 39.9542 18.8548 8.25477 7.63818 -34.14 -5539 4 39.6086 40.5348 18.1328 12.8912 -23.3113 16.3656 -5540 4 39.4227 40.1355 19.596 -22.4924 5.25798 25.9214 -5541 6 49.2764 23.011 30.5163 -3.77364 -44.6036 15.8547 -5542 4 49.4289 23.7872 30.0082 18.6126 30.182 -14.9565 -5543 4 49.9621 22.8706 31.1946 3.66181 18.5012 -4.70792 -5544 6 10.3518 2.34263 9.13761 -0.60969 70.0656 33.4022 -5545 4 10.2194 1.51752 8.76453 -19.3013 -48.5596 -30.1763 -5546 4 9.57958 2.95755 9.02478 16.8019 -18.7251 -1.57756 -5547 6 9.61453 40.9339 19.7468 19.8516 -54.9951 -16.0575 -5548 4 9.63195 40.6865 18.7859 0.317082 16.3896 20.6195 -5549 4 10.0376 40.0904 20.1458 -24.9194 43.0231 -10.2629 -5550 6 29.2525 5.10109 17.4961 7.67774 22.6856 2.90325 -5551 4 29.0408 4.77134 16.6193 -6.82779 -3.03985 -6.7526 -5552 4 29.5295 6.02934 17.3335 -2.58265 -16.5067 4.76001 -5553 6 27.0985 15.4102 3.23556 -13.4453 -81.1273 -7.3603 -5554 4 27.3652 16.2806 3.27349 18.8182 67.1491 11.283 -5555 4 27.7776 14.8512 3.68225 -14.3437 21.6428 -0.863725 -5556 6 32.8444 39.3852 25.121 -7.01244 -52.8845 44.4676 -5557 4 32.5131 40.2222 24.9368 -10.8075 51.8916 -16.2411 -5558 4 32.4445 39.2315 26.0289 16.1191 -0.874654 -30.671 -5559 6 34.9513 7.88207 31.2328 20.4504 58.5219 2.42802 -5560 4 34.2036 8.45679 31.498 3.65199 -12.2289 -1.35309 -5561 4 34.6861 6.99719 31.2488 -20.0023 -44.0519 1.25651 -5562 6 6.12467 36.7605 26.1486 23.5936 30.152 20.8626 -5563 4 6.61267 37.4751 26.6609 -18.7565 -29.2185 -15.3031 -5564 4 6.64666 36.6639 25.3566 0.873799 -8.15108 -9.63468 -5565 6 6.01736 25.8242 24.1032 -23.71 11.4997 43.6127 -5566 4 6.27054 25.4519 24.9889 5.69321 0.899098 -34.3464 -5567 4 5.25039 26.3671 24.4036 11.002 -12.3451 -22.9516 -5568 6 45.616 24.3868 2.54557 6.93899 11.9467 -1.18645 -5569 4 46.5025 24.2318 2.18535 0.269069 -11.0786 2.08994 -5570 4 45.6283 24.2142 3.48441 5.93067 -6.10702 12.3332 -5571 6 15.5106 11.7053 32.6869 22.7313 15.5035 25.4621 -5572 4 15.7644 12.551 33.1413 -9.31293 -24.2108 -12.4541 -5573 4 14.956 11.9719 31.9681 -12.2379 8.7831 -14.7046 -5574 6 46.4141 17.7037 37.4783 -24.8433 -42.9552 -46.1347 -5575 4 46.5841 17.8832 38.3706 6.4658 9.03355 44.3658 -5576 4 46.0203 16.778 37.4148 6.08678 36.5836 2.96135 -5577 6 39.713 20.917 18.528 13.2313 30.5311 40.8197 -5578 4 40.433 20.5782 18.0298 13.2747 -18.0123 -24.5712 -5579 4 40.2054 21.5165 19.1543 -30.2447 -12.7963 -15.6911 -5580 6 23.8051 28.0334 36.6648 -18.7533 17.1228 48.8478 -5581 4 23.301 27.37 37.1661 8.15196 -5.41595 -20.5023 -5582 4 23.699 28.7533 37.3439 14.557 -4.10395 -29.4534 -5583 6 23.235 0.659798 30.8906 16.7198 -34.3804 0.301059 -5584 4 23.3562 41.8891 31.5781 -2.93034 5.1259 -1.85649 -5585 4 23.9222 0.433479 30.2226 -16.4688 10.6885 3.12481 -5586 6 37.1438 6.89027 28.2945 -2.75708 2.50278 32.0481 -5587 4 36.7625 6.23385 28.9496 14.7229 22.3106 -21.8828 -5588 4 37.4874 7.65333 28.8474 -13.0775 -21.14 -18.6628 -5589 6 3.23769 6.61111 12.3846 0.723209 -17.9385 -9.61551 -5590 4 2.93962 6.7917 11.4726 6.04883 11.0603 10.3219 -5591 4 3.59705 5.70622 12.3141 -7.8292 10.6871 9.81534 -5592 6 12.6213 19.1513 31.1215 -11.7593 -39.2703 -9.13055 -5593 4 12.5689 18.1911 31.4279 4.41954 36.1073 -0.401864 -5594 4 12.3049 19.0952 30.1995 4.23471 8.33584 13.9505 -5595 6 15.1895 38.3194 41.5508 -8.26313 0.106571 5.96729 -5596 4 15.4027 38.685 40.6867 1.58925 3.7734 1.08261 -5597 4 15.977 37.8419 41.8199 8.82113 -1.67422 -0.112624 -5598 6 49.6344 33.3417 19.6414 -43.1776 -42.2962 -0.847743 -5599 4 48.6794 33.3996 19.9697 35.2792 3.84356 -17.7841 -5600 4 49.66 32.3974 19.2778 11.8172 40.1309 17.1575 -5601 6 6.36572 2.78375 29.9004 1.05055 15.8156 -22.8281 -5602 4 6.36575 3.75042 29.7262 1.90425 -15.9719 7.25575 -5603 4 5.96593 2.68858 30.7619 0.24665 -4.47807 16.8647 -5604 6 13.1696 31.768 30.2754 -6.44409 10.1839 -14.6274 -5605 4 12.7931 32.0108 29.386 8.00869 -8.49993 19.6421 -5606 4 12.9985 30.8211 30.4317 -1.17466 7.15103 -3.10169 -5607 6 32.315 32.2433 24.9103 28.3535 -13.0924 -48.465 -5608 4 32.6582 31.5201 24.3183 -18.8106 4.4732 28.5514 -5609 4 32.6906 33.004 24.4312 -3.21058 9.63112 20.1287 -5610 6 42.0003 14.5628 37.421 -39.889 12.6212 -8.37855 -5611 4 41.095 14.1415 37.3281 37.9102 -1.96214 -0.320241 -5612 4 42.7025 13.9066 37.3517 -4.02931 -15.6388 2.60245 -5613 6 11.8892 7.23447 27.6701 3.45884 -4.12236 4.5236 -5614 4 11.8415 6.40302 28.2109 -4.80024 17.2153 -14.4092 -5615 4 11.297 7.16355 26.8983 -0.411327 -9.99206 8.34553 -5616 6 14.2054 37.5349 6.88535 -5.50304 -50.1586 -23.8091 -5617 4 14.4448 38.4425 6.82842 11.1201 34.2121 -5.16838 -5618 4 14.5404 37.0855 6.04727 -8.45912 19.5264 31.302 -5619 6 14.2389 30.7101 36.0658 7.9951 22.3707 -6.00421 -5620 4 14.3369 30.7582 35.119 5.20948 5.89711 -15.5268 -5621 4 14.162 29.7856 36.1796 -2.50712 -40.828 17.27 -5622 6 16.4199 33.6465 5.49971 39.8982 -12.4718 -37.0106 -5623 4 16.8881 34.472 5.38053 -10.1033 13.7438 12.8324 -5624 4 16.9383 33.116 4.82328 -31.4907 -2.1142 22.2677 -5625 6 23.0347 17.1509 7.84843 -2.98061 53.305 10.417 -5626 4 22.2528 17.4913 7.37616 0.35347 -20.1342 1.7373 -5627 4 23.3535 18.0122 8.2624 2.91922 -40.8936 -9.01863 -5628 6 51.739 20.8998 27.7117 45.1346 -9.91933 19.8422 -5629 4 51.4539 20.5938 28.5983 0.576611 5.87017 -14.8878 -5630 4 52.7517 20.9693 27.7878 -43.3794 -0.870523 -11.1135 -5631 6 2.19386 27.6013 28.8077 21.9852 1.77593 -20.6905 -5632 4 2.90112 28.2633 28.7865 -8.94698 7.25322 21.5481 -5633 4 2.57794 26.9939 28.1568 -21.2327 -10.3447 8.82052 -5634 6 17.2209 14.3445 7.70498 -9.6153 -40.0176 25.3709 -5635 4 16.7414 14.2178 8.5755 19.2823 5.01031 -25.0594 -5636 4 17.7242 13.4894 7.54274 -12.7499 32.9606 1.11211 -5637 6 12.4553 8.94194 14.7093 23.4905 -30.5738 22.1451 -5638 4 12.3295 7.96561 14.6517 -10.6336 18.1935 -14.5798 -5639 4 13.0902 8.95069 15.466 -13.8235 22.031 -14.7981 -5640 6 42.4163 38.0607 9.75492 -41.3892 12.3524 0.930734 -5641 4 43.2155 37.8504 10.1985 23.5031 -2.65638 19.8551 -5642 4 41.8128 38.5249 10.3845 19.1619 -5.0707 -9.72644 -5643 6 51.8291 30.3524 28.2725 -23.4976 -15.3182 24.0858 -5644 4 51.4769 31.1806 28.0071 -16.9091 20.9854 -6.54852 -5645 4 52.5669 30.2698 27.7075 37.0459 -10.0857 -13.876 -5646 6 0.173291 18.5306 4.58887 -6.78508 26.3933 6.63194 -5647 4 0.366643 18.0957 3.77581 2.61413 -8.62723 -27.1515 -5648 4 0.528197 17.9664 5.25604 0.668563 -20.2899 17.5992 -5649 6 34.1542 0.618182 3.01035 -64.6642 7.59467 -29.5426 -5650 4 33.2756 0.91071 2.55681 38.9521 -14.8268 28.0312 -5651 4 34.8139 1.0189 2.46529 20.392 14.9436 -5.19898 -5652 6 49.1703 17.2445 23.163 11.3421 -28.7232 -23.3687 -5653 4 50.0948 17.5226 22.997 -11.4987 -1.8789 7.34388 -5654 4 49.1149 16.3391 22.7575 3.35316 27.0342 8.27414 -5655 6 23.1508 6.50484 23.6205 15.3745 23.1125 -33.0506 -5656 4 23.1854 7.14565 22.8174 -14.1016 -25.0292 28.8988 -5657 4 22.2566 6.27815 23.8868 -11.3625 11.3028 -1.57795 -5658 6 11.0777 24.0866 29.2726 3.42799 -14.5151 -26.2344 -5659 4 11.3051 23.4915 28.5104 -10.7193 12.1306 15.2701 -5660 4 11.7189 23.8646 29.9475 6.00027 1.59973 10.1126 -5661 6 36.5499 4.08922 21.6769 -9.80126 5.87302 -21.3361 -5662 4 36.3976 4.50823 22.521 3.21878 -0.144303 13.033 -5663 4 36.3054 4.80832 21.0596 6.63301 -13.9203 1.83546 -5664 6 31.3023 25.6432 24.5943 15.0376 6.85795 28.0728 -5665 4 31.291 26.2789 25.3519 -12.6017 -14.5788 -25.478 -5666 4 32.0941 25.1064 24.7955 -9.59576 -0.449362 -7.93794 -5667 6 42.6065 23.029 14.7662 -46.2562 -12.0705 -53.1337 -5668 4 42.8654 23.3474 13.8766 8.33796 6.77145 13.2285 -5669 4 43.1929 23.285 15.4255 44.8404 21.8098 38.991 -5670 6 14.3111 11.6689 8.88632 -19.0153 -23.9468 -21.906 -5671 4 13.3495 11.3817 8.87766 31.9146 14.5471 0.24728 -5672 4 14.742 11.0378 8.25313 -7.14597 12.5116 20.7778 -5673 6 21.4992 2.13393 3.40246 8.36864 -2.88126 -9.61958 -5674 4 22.4231 2.22963 3.69686 -12.58 -3.45743 -2.69439 -5675 4 21.4721 1.34946 2.81138 2.62282 6.56171 18.4043 -5676 6 22.4667 27.6841 39.0793 -16.1771 -11.2193 -33.3168 -5677 4 22.9487 28.2311 39.6723 13.8114 13.1168 21.0188 -5678 4 22.2331 26.8853 39.529 -0.753476 -8.75647 11.2468 -5679 6 37.2752 33.5075 30.0534 -5.09816 -29.8969 21.2662 -5680 4 36.5321 32.9121 30.2938 11.1992 13.6878 -5.37502 -5681 4 38.0391 33.1092 30.5204 -9.59535 7.6329 -11.7718 -5682 6 41.8356 20.8755 40.0084 -30.1785 -26.2846 -15.3963 -5683 4 40.891 20.6843 40.2338 21.7839 7.55089 -6.55796 -5684 4 42.213 21.2736 40.7728 12.4306 8.07023 23.0746 -5685 6 10.0585 31.1051 22.2503 24.8691 -18.1602 32.094 -5686 4 10.0242 30.9652 23.2199 -0.323131 -4.21186 -18.2592 -5687 4 9.26251 31.5457 22.0526 -32.5358 14.9165 -12.561 -5688 6 24.2061 35.3797 6.65176 29.8647 -7.74501 -52.0461 -5689 4 23.2981 35.13 6.46942 -12.5131 3.59528 11.7489 -5690 4 24.436 35.6291 7.5325 -13.5066 3.92126 26.0938 -5691 6 54.2205 13.3707 18.7548 -14.8606 0.23157 2.49876 -5692 4 53.5905 13.2954 18.0026 12.0308 5.79113 16.3195 -5693 4 53.7072 13.5032 19.578 4.97112 -2.65932 -16.1217 -5694 6 12.4895 25.0856 17.4479 -5.54126 21.12 19.6166 -5695 4 12.0527 25.8035 17.9613 1.96295 -15.4272 -10.9144 -5696 4 12.9797 24.5872 18.1192 -7.22993 -2.38631 -13.5888 -5697 6 22.3914 33.9622 18.8899 -17.7941 -3.8788 -25.186 -5698 4 22.7777 34.3519 18.0802 1.20341 3.55679 12.7761 -5699 4 21.5828 33.5138 18.532 26.0363 5.82114 13.25 -5700 6 24.4442 12.917 5.83205 -1.35281 -9.13891 6.68087 -5701 4 24.5112 13.8355 6.04562 11.139 23.8521 5.95609 -5702 4 23.7978 12.9208 5.12829 -4.38592 -8.75699 -5.70796 -5703 6 13.4045 11.2384 28.602 -9.94106 -32.5269 -0.345522 -5704 4 13.7125 10.4202 28.1467 1.06973 22.7078 1.68844 -5705 4 12.6883 10.856 29.1417 2.50959 12.0169 -5.49025 -5706 6 20.9681 34.6931 21.1354 15.1203 14.42 -6.16036 -5707 4 21.5009 35.1121 21.8248 -8.94458 -7.77672 4.1779 -5708 4 21.5063 34.8208 20.3262 -11.2236 -10.4562 8.09593 -5709 6 37.1336 34.5207 26.1541 -9.5297 -36.7224 -3.07541 -5710 4 37.2109 34.2142 25.2288 3.21082 15.1766 11.7274 -5711 4 37.5352 35.3664 26.2639 8.9577 18.3348 -6.65469 -5712 6 49.3622 27.1182 23.4746 39.7066 -11.0301 13.9767 -5713 4 48.4746 27.3502 23.3119 -43.65 9.96054 -8.06751 -5714 4 49.6716 26.7458 22.6451 -3.30563 -9.15784 -7.68388 -5715 6 2.6564 41.733 27.6477 -1.65257 -10.3676 0.180548 -5716 4 2.5349 41.5868 26.6785 2.71482 14.5166 10.808 -5717 4 3.44733 0.360291 27.8573 -13.8821 -2.9337 -13.5775 -5718 6 28.2538 5.65865 0.855763 -50.2522 -11.1502 7.99105 -5719 4 29.1126 5.92525 0.635025 43.8938 8.11388 -11.2713 -5720 4 28.2366 4.68907 0.832778 5.05155 4.08711 2.73992 -5721 6 46.3376 19.9476 30.6448 -5.32264 7.02196 22.3264 -5722 4 46.9473 19.8004 29.9179 3.84913 9.17517 -5.42643 -5723 4 46.6125 20.7672 31.1318 -5.12963 -19.3092 -16.4827 -5724 6 3.64577 25.7701 21.5553 -12.766 27.4814 -12.397 -5725 4 3.72382 24.8593 21.8343 3.84868 -9.88757 -5.52558 -5726 4 3.13913 25.8588 20.7173 13.2009 -15.3518 9.10855 -5727 6 2.75122 19.0968 29.6319 -2.61118 -0.882922 8.96218 -5728 4 3.5891 18.6871 29.8565 3.14038 -9.81989 10.1431 -5729 4 2.90737 19.4327 28.7602 3.1882 14.1904 -12.7773 -5730 6 11.8953 35.7778 24.2646 -23.8517 23.4638 0.926703 -5731 4 12.2722 34.9198 24.2954 23.5909 -23.1933 0.784725 -5732 4 12.5229 36.3761 23.8548 12.2449 3.68762 -3.83655 -5733 6 52.3409 30.3775 14.3038 25.9342 24.3497 3.27132 -5734 4 52.8186 31.1218 14.7277 1.28259 -10.3571 -1.87569 -5735 4 51.5459 30.7912 14.0165 -25.7225 7.74731 -5.34623 -5736 6 0.083662 24.3704 32.1159 7.87696 -1.86575 0.949534 -5737 4 0.925887 24.7254 31.8116 -7.58302 1.2158 -10.0766 -5738 4 0.064605 24.6797 33.0182 -11.6947 5.89195 12.8097 -5739 6 31.4941 23.7355 38.8139 13.6067 4.55671 22.3988 -5740 4 31.5922 23.3599 39.6955 6.6148 17.5079 8.63317 -5741 4 30.9989 23.0266 38.4646 -21.4094 -18.5611 -29.2329 -5742 6 52.1193 21.6104 3.49599 14.6151 -31.0847 -13.388 -5743 4 52.9641 21.5934 2.99085 -20.8635 4.42776 5.19501 -5744 4 52.1025 22.4297 3.95509 1.85636 27.8943 8.87727 -5745 6 31.7523 33.9412 11.6017 9.59211 -24.6365 -8.99112 -5746 4 31.343 34.2459 12.4067 -7.95657 10.1636 10.9534 -5747 4 32.0734 33.0348 11.7994 -4.73133 20.193 -2.42319 -5748 6 7.03486 17.6719 16.6685 29.0057 -41.5114 -49.367 -5749 4 6.91092 17.0215 17.3537 -7.78637 4.64801 28.8113 -5750 4 7.29826 17.0034 15.9319 -18.9591 50.1453 28.7374 -5751 6 51.8542 41.8728 22.1898 10.246 17.2442 -13.5357 -5752 4 52.3028 41.4443 22.9054 19.3182 -6.61148 18.5368 -5753 4 51.1068 41.3135 22.0792 -27.0964 -11.4612 -2.03348 -5754 6 50.8737 9.93347 25.9376 -32.929 -21.31 0.307119 -5755 4 50.6075 10.0984 25.0351 -2.54905 2.45869 -5.94774 -5756 4 51.7134 10.3221 26.0527 29.2363 20.0336 5.9403 -5757 6 9.00178 39.8723 13.8451 -19.3622 -18.1235 -30.983 -5758 4 9.55792 39.3182 14.3856 9.60602 -5.37935 8.26515 -5759 4 8.70771 39.29 13.0873 14.4347 20.6992 23.854 -5760 6 40.6986 25.5526 0.136544 19.9096 -17.3535 33.0343 -5761 4 40.3666 25.3638 1.04053 0.834228 7.76146 -13.9079 -5762 4 41.6521 25.7245 0.296606 -16.7956 -8.725 -14.7957 -5763 6 46.6823 7.83196 22.8561 10.1499 25.8504 33.9562 -5764 4 46.2788 7.49308 23.6743 -2.78909 -8.0392 -13.1915 -5765 4 47.099 8.65892 23.1926 -4.50937 -8.82075 -14.1875 -5766 6 20.9875 12.9068 9.95805 -11.691 32.2034 24.7109 -5767 4 21.4351 12.3054 10.5167 21.854 -26.8991 22.1196 -5768 4 21.3309 12.7465 9.11062 12.4417 -9.66517 -44.3579 -5769 6 24.8453 0.514421 28.6038 13.082 22.7197 -2.81433 -5770 4 24.715 0.071792 27.7548 -6.16819 -1.63374 -2.91335 -5771 4 25.0442 1.45997 28.4028 -6.72102 -19.281 3.08734 -5772 6 9.94041 22.6855 8.28517 -18.2906 18.759 -35.6321 -5773 4 10.3442 21.9586 7.83344 17.071 -18.1108 1.7387 -5774 4 9.60436 23.1702 7.48056 7.13277 7.40532 33.7222 -5775 6 33.2759 9.25429 23.8257 8.37106 -55.2845 13.9355 -5776 4 33.3237 10.1123 23.4806 -1.26345 47.1757 -20.4798 -5777 4 34.1087 8.81977 23.5578 -8.47821 6.16632 5.2483 -5778 6 47.7984 20.3614 34.2959 -41.6158 20.0741 -32.6301 -5779 4 47.162 20.9095 33.7523 35.4977 -6.5354 18.8426 -5780 4 47.2264 19.5923 34.4121 13.8381 -6.37745 11.1074 -5781 6 7.49292 13.4971 41.09 9.79805 -11.8131 -23.6679 -5782 4 7.49901 13.1324 40.1715 -6.0705 12.8605 17.5951 -5783 4 8.32745 13.1637 41.4633 -5.36906 3.36653 2.36319 -5784 6 9.96112 23.6102 1.61114 1.89646 0.256416 -8.05524 -5785 4 10.3422 24.1467 0.893187 3.70522 0.0162214 12.766 -5786 4 9.63217 22.8308 1.16111 -2.5861 -8.4474 -3.4617 -5787 6 27.3279 14.1675 11.3384 -16.3978 3.93745 18.7515 -5788 4 27.0565 14.7974 10.6584 -0.154384 0.736593 1.51299 -5789 4 26.9739 14.5213 12.1957 15.9081 -3.44829 -24.7787 -5790 6 25.8416 31.7729 17.8867 -18.6075 -57.137 -13.4601 -5791 4 26.5498 31.1652 17.5816 -7.88637 19.42 8.67928 -5792 4 26.1364 32.6121 18.1157 31.0786 47.9057 11.8145 -5793 6 28.5054 34.3394 0.220618 54.67 33.5077 11.5224 -5794 4 29.0324 33.8757 0.885908 -4.94848 -3.20805 0.921423 -5795 4 27.711 33.8992 0.092994 -46.8158 -31.9819 -6.78258 -5796 6 39.4821 27.6754 22.7241 37.6977 26.8974 -34.7457 -5797 4 38.562 27.8477 22.7631 -35.1425 8.51836 6.28403 -5798 4 39.8483 28.4606 22.2037 -4.4779 -30.5719 17.4824 -5799 6 19.3989 35.5068 37.6449 44.7238 7.00696 26.241 -5800 4 18.7939 34.9286 37.217 -17.2642 -20.3375 -13.2178 -5801 4 20.0787 34.9056 38.0699 -27.4009 15.1777 -18.4057 -5802 6 40.2622 30.2205 10.7395 23.7464 -4.20556 -44.2191 -5803 4 39.872 30.2327 11.5724 -12.5687 -7.32393 56.9787 -5804 4 39.6265 30.6987 10.2193 -5.46151 14.1383 -16.826 -5805 6 44.8252 28.4803 36.0885 -55.5401 -40.4399 48.4955 -5806 4 44.0914 27.9458 36.6324 49.8455 26.3412 -39.6007 -5807 4 44.7386 29.3482 36.4954 11.2485 4.05282 -13.3799 -5808 6 17.9305 13.9374 34.278 5.37655 43.1893 -39.9004 -5809 4 17.3503 14.7126 34.0365 12.4853 -29.216 13.3111 -5810 4 17.5732 13.4499 34.9957 -23.6035 -11.4222 25.4792 -5811 6 22.772 11.7897 25.9182 -5.92321 66.9234 -24.4623 -5812 4 22.4079 10.9608 26.1065 -2.80798 -46.2844 14.8143 -5813 4 23.7282 11.8442 25.9391 13.2658 -20.917 3.34216 -5814 6 27.9678 31.9745 40.3581 9.67064 -3.036 11.5355 -5815 4 28.3415 32.7469 39.952 3.83939 12.9153 -6.44865 -5816 4 27.8423 31.3481 39.6454 -9.64166 -7.41544 0.62615 -5817 6 29.7189 5.14175 29.7003 46.1252 -36.6163 -19.9261 -5818 4 29.2969 5.47215 30.4671 -15.8461 16.6952 32.1509 -5819 4 30.5834 4.69597 30.0017 -39.473 23.5261 -13.8417 -5820 6 3.10812 21.482 2.76797 0.178067 -30.2305 -7.76436 -5821 4 2.88389 22.394 2.68207 -8.68283 21.8462 0.431797 -5822 4 2.52465 20.9987 2.15107 4.11904 7.00085 10.9335 -5823 6 13.6455 30.6616 39.7413 -31.0251 6.24286 -53.6991 -5824 4 14.4958 30.9276 39.9901 40.59 7.52955 18.7737 -5825 4 13.6028 30.9637 38.7781 -13.7388 -14.6365 40.9566 -5826 6 39.1879 23.0833 28.2631 23.8153 34.0131 -40.8644 -5827 4 39.3603 23.1915 27.276 -9.32936 -4.03115 31.7012 -5828 4 38.6771 22.3028 28.3825 -19.3689 -24.2853 3.44718 -5829 6 16.9942 23.7475 0.782551 23.2332 -11.0525 -6.02825 -5830 4 16.1835 23.4907 1.22514 -0.204047 -3.07314 3.44284 -5831 4 17.6924 23.1245 1.11262 -18.9135 18.2649 -2.71213 -5832 6 0.34625 33.6655 13.0265 -29.0282 32.855 38.2597 -5833 4 54.9333 33.1158 13.7076 7.16186 -20.0974 -8.4449 -5834 4 0.196186 34.5312 13.5136 21.864 -23.0202 -35.8666 -5835 6 49.1134 40.6592 16.9502 -22.6074 7.13526 -12.7963 -5836 4 49.0929 41.0585 16.0481 9.95068 -10.3513 11.1088 -5837 4 48.1763 40.6949 17.2078 7.5264 3.31219 -3.37923 -5838 6 52.1371 39.9932 15.179 23.5783 8.13152 6.60826 -5839 4 51.9212 40.0798 16.1068 2.92809 -1.65288 7.91558 -5840 4 51.3496 39.6649 14.7978 -27.1925 -6.99882 -20.2103 -5841 6 29.0492 37.0934 37.8397 27.862 0.580994 -15.5106 -5842 4 29.7824 36.6456 38.29 -13.83 -0.942856 -3.03347 -5843 4 28.3401 37.1923 38.4583 -14.8343 8.34268 17.6028 -5844 6 4.87483 1.47389 27.5722 8.99005 1.78018 0.412076 -5845 4 5.18955 1.04652 26.7639 -2.94161 4.65408 6.15856 -5846 4 5.65876 1.67721 28.1054 -5.69693 -0.488114 1.02013 -5847 6 43.5905 24.3648 30.2005 -22.2044 -15.6763 19.9702 -5848 4 44.3573 23.9419 29.8442 19.8319 -9.6252 -11.3654 -5849 4 42.9995 23.6287 30.4468 4.54232 11.3491 -5.57307 -5850 6 33.7546 3.53169 22.9281 6.20171 -10.3572 -20.5792 -5851 4 34.1788 2.72522 22.5548 -7.61164 22.2296 6.95503 -5852 4 33.66 4.19918 22.2026 -0.715781 -19.232 19.3758 -5853 6 19.8847 13.4579 25.4063 -13.0952 -9.58357 -31.6265 -5854 4 20.5464 14.0819 25.6574 14.0517 10.8301 14.4774 -5855 4 19.8633 12.7253 26.0209 8.35596 -5.88238 10.9252 -5856 6 47.3765 23.175 39.6238 -8.62258 12.6683 8.16714 -5857 4 47.7656 22.5263 39.0394 4.03481 -11.1372 -12.2265 -5858 4 47.7314 24.026 39.3382 2.38196 -1.35255 2.76448 -5859 6 20.1792 18.6695 32.3892 10.8118 -11.8558 9.82813 -5860 4 19.7451 19.3837 31.9609 -18.6549 15.8768 -14.4176 -5861 4 21.1063 18.8885 32.2904 5.57481 -8.22146 4.6255 -5862 6 0.469489 5.80056 25.6694 -18.1951 25.8664 -34.3154 -5863 4 0.192512 6.63022 25.2132 12.4788 -26.9708 -4.90825 -5864 4 0.599388 6.15564 26.5295 8.98284 3.20038 34.2611 -5865 6 6.87796 19.5502 31.9212 -30.9469 28.3562 -15.4034 -5866 4 6.36899 19.9719 32.666 7.94508 -11.3044 -26.1662 -5867 4 6.51823 19.9652 31.058 21.1032 -17.2362 32.6466 -5868 6 6.72006 20.2763 38.5282 -5.5716 11.964 -18.9783 -5869 4 5.89143 20.7831 38.5761 11.8801 -4.42879 -4.55199 -5870 4 6.91977 20.0675 39.4366 -2.33705 -6.77268 4.9945 -5871 6 22.0131 25.9408 12.2669 -3.54377 -45.9259 -44.7125 -5872 4 21.4169 25.4251 11.6232 6.06411 36.0021 36.1209 -5873 4 22.8575 25.5519 12.0003 5.79029 4.70211 8.19546 -5874 6 39.2956 7.94468 2.64777 3.93347 -3.54621 1.69719 -5875 4 39.6192 7.96721 3.55942 2.89932 9.4301 1.57912 -5876 4 39.5223 7.0665 2.33247 5.57505 -8.53159 -3.65477 -5877 6 29.9733 22.0379 34.4029 6.80249 8.99144 -26.5663 -5878 4 30.9486 21.9114 34.4332 -22.6925 2.47334 -4.63229 -5879 4 29.7282 22.2324 33.4511 1.23467 -5.29722 31.1857 -5880 6 37.585 16.2896 0.378862 9.66072 -32.1652 -13.4334 -5881 4 37.1738 15.3958 0.469359 7.4986 19.6703 2.82788 -5882 4 38.3979 16.0784 41.7811 -5.81955 5.34443 7.8674 -5883 6 11.7199 13.8969 21.9024 0.976022 -4.28814 -52.9061 -5884 4 11.762 13.5091 20.9636 8.25344 3.74313 41.2159 -5885 4 11.7301 13.2111 22.5694 -0.197866 -18.3587 0.721586 -5886 6 33.3547 10.9227 27.6206 7.79028 2.98821 -12.2755 -5887 4 32.7398 11.5851 27.2614 8.9286 -8.03905 3.2582 -5888 4 34.0693 10.7866 26.9485 -19.1033 10.7299 13.3482 -5889 6 30.9479 36.5351 10.0985 1.61282 -58.9885 -21.8283 -5890 4 31.0506 36.3975 9.1055 -4.33965 11.8991 35.1417 -5891 4 31.0192 35.5887 10.4601 -6.41155 39.3119 -7.26857 -5892 6 45.5784 6.55949 25.24 49.1938 -13.828 -6.30557 -5893 4 44.6777 6.5515 25.5065 -25.461 -8.09624 7.65514 -5894 4 45.978 5.64009 25.2752 -26.9592 28.1751 -0.0529727 -5895 6 9.53089 30.0259 12.0468 18.203 -29.4993 -35.3826 -5896 4 9.87965 30.5113 11.2809 1.8895 2.86193 6.03312 -5897 4 9.26134 30.6784 12.652 -18.7794 25.6859 27.1844 -5898 6 53.0787 24.9761 1.37462 5.70131 11.5656 52.3682 -5899 4 52.7701 24.171 1.02302 -14.9871 -27.078 -25.8882 -5900 4 53.2426 25.5756 0.676612 4.18045 17.0305 -26.7636 -5901 6 26.1794 24.7359 0.502901 22.1176 -25.6344 -30.1555 -5902 4 25.7034 24.7594 41.5454 1.42755 5.35042 26.0986 -5903 4 25.8798 25.3805 1.12222 -18.0425 21.9232 11.274 -5904 6 23.006 2.41877 11.549 3.03835 0.786733 -23.201 -5905 4 22.1232 2.19651 11.8728 1.75899 -1.65202 1.96434 -5906 4 22.9163 2.42328 10.5701 -3.31062 2.24291 13.1011 -5907 6 29.9286 12.8953 30.9894 2.56623 -0.427284 6.89615 -5908 4 30.7531 12.7948 31.5295 -11.6926 9.48208 -25.7239 -5909 4 30.1452 13.1242 30.0532 3.97045 -7.90132 21.6369 -5910 6 24.0654 16.1863 40.3478 -8.57837 -16.1993 -7.0618 -5911 4 23.8181 16.8167 40.9886 -17.7345 17.1107 43.7161 -5912 4 24.4461 16.799 39.7307 8.03288 -6.21636 -19.956 -5913 6 21.8775 29.9129 12.7438 8.38993 20.3936 0.69825 -5914 4 21.1101 29.6022 12.2761 -16.411 -9.00989 -4.05561 -5915 4 21.7959 30.8814 12.6689 6.66677 -10.3308 5.74649 -5916 6 45.2196 12.276 6.62528 -23.2047 44.1078 30.1736 -5917 4 45.4494 11.529 6.11864 16.0879 -27.9404 -20.133 -5918 4 45.9267 12.944 6.63915 -2.18395 -9.27911 -10.7446 -5919 6 7.59043 25.3914 38.0243 42.7544 -18.087 21.3587 -5920 4 8.2454 25.1294 37.3073 -28.6085 13.3538 22.5553 -5921 4 8.06078 25.1795 38.9036 -17.5445 13.8955 -36.9473 -5922 6 46.1702 7.81994 16.6869 -21.8749 40.0263 -11.2018 -5923 4 46.5308 7.86296 15.7811 2.96678 -6.7279 9.6444 -5924 4 46.6568 7.20863 17.2067 24.29 -27.7199 6.2944 -5925 6 54.9712 12.8519 7.72645 -5.0392 -7.84126 -11.592 -5926 4 54.9715 13.8156 7.65436 -3.45199 -1.13943 9.08655 -5927 4 54.3111 12.5688 8.37934 8.51313 12.0297 -0.864167 -5928 6 26.936 39.6495 37.1759 1.87165 14.912 18.6021 -5929 4 27.6928 39.6002 36.5592 -3.34619 -10.0228 14.3716 -5930 4 27.1866 39.3914 38.108 -0.832196 -0.678219 -33.4669 -5931 6 27.0349 8.92218 38.0169 24.6524 -2.61622 -28.7715 -5932 4 26.316 9.52058 38.1337 -23.9094 17.4181 8.51603 -5933 4 27.4852 9.31616 37.2255 -4.7843 -14.0734 18.554 -5934 6 8.05135 7.65161 29.9116 12.1299 -7.94147 21.2544 -5935 4 8.62851 7.92802 30.6495 -6.35395 -5.29094 -12.0163 -5936 4 7.74814 8.47335 29.5547 -5.2558 18.4649 -14.2469 -5937 6 27.8737 27.8565 12.1051 -38.6038 15.3188 22.9885 -5938 4 27.4445 28.7122 12.3849 14.7215 -19.9621 -4.23437 -5939 4 28.6312 28.0341 11.5799 28.6137 10.9177 -18.1106 -5940 6 23.5548 30.5037 38.1558 -29.4871 -31.9475 26.5081 -5941 4 24.0962 30.758 38.9126 3.93335 7.76671 -5.43794 -5942 4 23.9417 30.8351 37.3772 21.2145 16.4773 -23.4003 -5943 6 48.0793 24.306 17.3344 -19.3615 12.8085 -14.3801 -5944 4 47.2872 24.7421 17.7455 27.359 -7.68532 -3.4425 -5945 4 48.1537 24.7387 16.4546 -0.580236 -6.90317 13.1114 -5946 6 38.498 5.30294 40.3305 40.7021 23.5094 2.62433 -5947 4 38.9475 4.64687 39.7972 -10.9193 -18.4764 2.07144 -5948 4 39.1882 6.01706 40.3225 -28.8653 -3.92995 8.38836 -5949 6 31.2337 3.92695 33.7301 -2.6422 16.6026 -6.87478 -5950 4 31.7948 4.28658 33.0166 -2.97898 -8.44373 7.32517 -5951 4 31.5298 3.03423 33.9266 10.3473 -9.06319 -0.444766 -5952 6 41.2426 8.81864 38.1104 -4.47266 -7.82466 24.3448 -5953 4 41.0373 8.41451 38.9755 -2.01902 1.52645 -10.1427 -5954 4 41.1368 9.75783 38.3095 7.23604 3.04516 -5.74389 -5955 6 53.3619 29.0937 24.5785 -40.2757 11.297 7.14485 -5956 4 52.5565 28.5537 24.7901 26.871 10.2044 -0.818821 -5957 4 52.9453 29.9599 24.3491 20.4755 -15.9472 -3.03 -5958 6 54.9044 15.544 40.7081 25.545 -57.3548 17.1629 -5959 4 54.9892 16.405 40.3633 -12.4948 43.2864 -12.4113 -5960 4 54.018 15.2891 40.9908 -7.57666 14.2468 -5.0348 -5961 6 46.3994 17.0672 31.8767 -6.245 16.1286 -17.5712 -5962 4 46.5114 17.9797 31.5283 3.34232 -11.2714 9.55259 -5963 4 45.8128 16.6602 31.1996 2.74349 5.02824 21.6551 -5964 6 36.898 25.0477 23.0493 11.3229 21.4084 -39.4528 -5965 4 37.2029 24.9737 23.9235 7.13326 -1.42781 43.2733 -5966 4 36.3025 24.3424 22.8486 -15.8402 -9.5757 6.36085 -5967 6 11.3692 4.41343 15.9249 15.7896 22.4119 -17.7964 -5968 4 11.3725 3.62473 15.3598 -3.28732 1.6252 14.2587 -5969 4 11.7055 5.11941 15.3214 -6.01385 -9.48847 12.8461 -5970 6 12.7845 7.07125 19.464 -10.6801 6.56169 22.7508 -5971 4 12.8604 6.27981 18.9655 14.1597 -21.8558 -24.6024 -5972 4 12.2771 6.71627 20.2197 6.8185 19.6013 -8.61559 -5973 6 12.0681 33.6471 17.5522 -1.52085 -17.496 -42.1785 -5974 4 11.9445 34.1189 18.3508 -6.25092 12.897 34.2466 -5975 4 12.5251 32.8183 17.7704 2.9394 6.95993 4.68875 -5976 6 10.2419 4.74292 2.55933 22.7613 10.361 1.71337 -5977 4 9.42389 4.50476 2.9876 -9.73314 -9.75152 7.74431 -5978 4 10.9687 4.12007 2.82053 -14.8261 2.90481 -11.2179 -5979 6 4.58785 36.8771 12.1606 -7.79451 -50.5455 -28.0593 -5980 4 4.4315 37.6675 12.6216 -0.588552 45.9766 17.7929 -5981 4 5.40236 36.9214 11.6472 0.781205 5.58305 7.99313 -5982 6 30.7591 35.3322 25.8391 -38.6972 -6.70904 -25.8809 -5983 4 31.308 35.3014 26.6139 2.09136 -3.6723 11.5509 -5984 4 29.8922 34.8696 26.0006 25.0535 4.09477 3.57125 -5985 6 20.1826 7.15897 1.87495 42.3449 13.1453 -15.8992 -5986 4 20.9155 6.54161 2.14653 -26.0098 16.5163 -6.36728 -5987 4 20.7109 7.92751 1.4772 -24.8109 -25.5601 12.7141 -5988 6 21.7554 6.89613 28.9929 -8.55274 -2.37394 -9.1913 -5989 4 22.0764 7.2366 29.8207 3.60587 3.07422 19.5812 -5990 4 22.5251 6.52709 28.5653 7.82832 -0.878326 -6.51175 -5991 6 6.87782 37.1389 6.94163 -1.13334 10.8563 13.3375 -5992 4 7.36847 37.9928 6.7949 -15.2779 -15.8129 7.53623 -5993 4 6.56156 37.0941 7.87645 12.8328 8.43507 -22.3513 -5994 6 37.1951 18.3599 16.3051 31.8484 54.3956 -63.0636 -5995 4 36.5686 18.6502 16.9278 -28.3708 4.63663 38.6073 -5996 4 37.3394 19.2548 15.8115 -3.93301 -42.965 18.1753 -5997 6 52.3874 25.498 31.3134 14.111 8.09505 3.74503 -5998 4 52.2596 26.4307 31.6656 16.8187 -33.1452 -9.3176 -5999 4 53.3531 25.244 31.2999 -24.6813 13.8962 6.4969 -6000 6 3.93514 39.8328 16.38 27.5969 -10.0907 -6.6773 -6001 4 3.11618 39.8354 16.8714 -5.56329 -11.6849 3.14974 -6002 4 4.25813 38.8985 16.2148 -16.7217 35.1377 3.93655 -6003 6 26.055 14.6352 18.3097 2.48745 23.0231 -5.4837 -6004 4 27.0121 14.5315 18.422 -4.58232 5.3017 0.111087 -6005 4 25.8831 15.6122 18.2324 0.591934 -25.1482 1.36918 -6006 6 22.1861 39.625 23.6336 -13.0035 -7.16992 22.0669 -6007 4 22.5756 40.4198 23.3178 20.0241 20.7615 -16.9022 -6008 4 21.775 39.9577 24.4575 2.36146 -17.5943 -7.81238 -6009 6 5.9827 12.8747 22.3739 5.28791 3.19174 -0.347139 -6010 4 6.16079 13.1981 21.4813 -0.557605 -0.80783 -0.954564 -6011 4 6.85402 12.6686 22.7296 5.64669 -4.60509 -1.11135 -6012 6 48.9358 28.1656 34.7093 -34.12 -15.1013 -7.57113 -6013 4 48.3009 27.4712 34.4428 -1.24475 21.7165 7.07681 -6014 4 49.7483 27.6911 34.6564 33.1581 1.27133 3.59264 -6015 6 7.76665 22.4378 33.2356 5.82113 4.36953 2.134 -6016 4 7.99414 22.0593 34.0982 -2.05459 -3.4103 -7.93698 -6017 4 7.15982 21.8587 32.7652 -2.05153 -2.03416 7.79212 -6018 6 41.0903 39.5994 11.7192 28.8485 25.6095 5.96672 -6019 4 40.6961 40.3697 11.3388 -29.9964 5.48828 -17.7316 -6020 4 41.854 40.0697 12.1081 -2.33823 -21.5528 5.66509 -6021 6 26.8801 37.922 39.3457 -9.67122 -13.15 30.7983 -6022 4 27.1418 37.9976 40.2903 -3.7646 7.48977 -14.0985 -6023 4 25.9915 37.5069 39.4007 11.6973 7.1772 -10.1587 -6024 6 16.8317 41.5399 16.7862 15.0313 6.40425 17.7164 -6025 4 17.5506 0.178386 16.4567 -5.24562 -1.69226 -13.3924 -6026 4 17.0965 41.4441 17.7156 -14.9292 -9.12078 -7.2801 -6027 6 19.02 8.9948 17.6728 1.01249 -20.0254 27.6053 -6028 4 18.8256 9.92734 17.8397 -2.50665 -0.780218 3.94781 -6029 4 19.0722 8.45531 18.5284 1.63313 22.2167 -34.6872 -6030 6 31.0993 24.379 20.1031 -5.45136 7.30173 -0.0135243 -6031 4 30.58 24.6604 20.88 7.69136 -4.59203 -13.2888 -6032 4 31.7465 25.0718 19.9526 0.652083 2.88804 -0.364555 -6033 6 24.6121 6.3117 27.596 -14.2942 3.47042 8.51555 -6034 4 24.6855 6.72112 26.7154 0.000835906 -11.6728 3.52597 -6035 4 24.4562 5.35726 27.5796 2.29956 0.742888 -9.80031 -6036 6 11.6309 5.33579 8.21245 48.3472 17.5789 -13.0214 -6037 4 10.7447 5.097 8.35577 -43.9811 -8.24091 9.59422 -6038 4 11.6324 6.14291 7.66014 -5.62825 -15.0071 6.92232 -6039 6 16.4828 34.2339 17.2467 58.9453 43.3211 -11.1422 -6040 4 15.833 34.737 16.7643 -22.9367 -4.06405 -2.05249 -6041 4 17.323 34.8225 17.0684 -41.083 -49.3458 15.3182 -6042 6 40.7431 40.4645 8.52128 12.2314 -11.8005 -21.5431 -6043 4 40.0246 40.6751 9.09883 -14.9736 5.2464 12.3608 -6044 4 40.4244 39.6664 8.05294 5.87539 10.603 6.78918 -6045 6 42.7463 5.87875 14.2877 12.74 -3.29305 -3.26541 -6046 4 42.0588 5.87807 14.9272 -15.1719 8.11415 20.4154 -6047 4 42.5132 5.11812 13.7588 -0.0411089 -3.23222 -11.0769 -6048 6 14.3659 21.065 6.06718 -46.5802 14.1632 25.7131 -6049 4 14.5381 21.6726 6.80844 -4.55135 -9.99097 -5.53618 -6050 4 15.2049 20.8313 5.76105 45.2018 -10.2131 -22.6687 -6051 6 16.2987 37.772 18.1217 -43.41 26.7654 24.2454 -6052 4 15.4242 38.2299 18.3727 36.2216 -25.3097 -28.3843 -6053 4 16.6845 37.7048 19.001 13.5629 -5.49997 -6.41318 -6054 6 40.7915 27.7152 27.1158 9.45156 2.81801 -4.91689 -6055 4 41.5456 27.319 27.566 -3.53201 -5.16081 10.0516 -6056 4 41.2155 28.2976 26.4751 -4.07016 3.79859 -1.40954 -6057 6 44.9595 25.9846 14.0499 3.3218 -15.4841 -8.79479 -6058 4 45.329 25.1566 13.6433 -5.22711 26.2877 13.1546 -6059 4 45.4837 26.7406 13.7529 4.37393 -9.76715 -6.45081 -6060 6 2.62066 33.9505 21.2427 -16.9582 -3.86849 -3.69815 -6061 4 2.06211 34.7496 21.3041 9.37305 -3.74186 4.79914 -6062 4 2.1388 33.3568 20.6382 5.47892 10.3925 4.65279 -6063 6 5.77806 4.43691 12.8378 4.70319 28.9306 -8.8144 -6064 4 5.36233 3.72198 13.3221 -5.81749 -8.58488 4.20714 -6065 4 5.80863 5.24637 13.3804 -1.3041 -13.5761 2.8333 -6066 6 16.8665 5.92021 7.40582 23.56 -3.08178 3.03829 -6067 4 16.4354 5.08697 7.20958 -2.89912 -12.7512 -7.28137 -6068 4 16.1638 6.54304 7.4701 -21.737 13.5702 4.65232 -6069 6 17.8259 38.4084 36.8446 -8.45971 28.6621 19.1884 -6070 4 17.7005 39.3712 37.0468 11.155 -18.7052 -15.1769 -6071 4 18.5325 38.3077 36.2071 4.43545 2.51623 -4.89916 -6072 6 43.3084 20.5973 5.4325 -39.7754 20.35 -2.23031 -6073 4 43.0204 21.5105 5.15286 19.9417 -23.843 3.70329 -6074 4 42.4274 20.1471 5.43024 22.0601 -2.53082 1.71294 -6075 6 21.5318 23.3 30.4444 10.3709 20.0389 -42.3415 -6076 4 21.0369 22.9394 31.1576 -20.9289 -4.03021 22.2109 -6077 4 20.911 23.6578 29.7428 10.7798 -15.246 22.7192 -6078 6 0.249866 28.0345 36.1724 -10.1983 37.6035 -27.6546 -6079 4 1.05324 27.7572 36.576 20.3102 -14.8665 16.9966 -6080 4 0.540234 28.832 35.6712 -10.982 -12.5736 6.41543 -6081 6 3.04754 17.0516 11.5683 -6.97145 7.64509 -15.3824 -6082 4 3.16434 17.3061 12.4746 3.36597 -0.550097 20.9912 -6083 4 2.52404 17.7798 11.2137 2.91457 -3.72579 -4.7217 -6084 6 24.1788 37.0366 23.9551 -12.9856 4.64226 12.2764 -6085 4 23.6099 37.826 23.831 6.85326 -8.75197 5.00341 -6086 4 24.4012 36.9865 24.9175 -1.53567 3.17074 -21.6248 -6087 6 3.95494 20.5134 27.4915 2.8093 53.7214 17.1103 -6088 4 3.58105 20.0931 26.7551 -14.7022 -26.8908 -38.8522 -6089 4 3.8118 21.4686 27.2477 5.25372 -20.6261 11.8203 -6090 6 54.8404 2.77723 29.6182 19.2518 19.5174 31.7291 -6091 4 54.8688 2.43537 30.559 -2.71579 12.5717 -24.6672 -6092 4 0.596183 3.44189 29.5911 -17.1059 -25.2514 0.407437 -6093 6 27.1931 8.41834 31.7378 -5.45838 77.4793 -29.1542 -6094 4 26.7872 8.25949 30.8671 -2.01983 -12.8877 1.93898 -6095 4 27.4107 9.43311 31.6496 -7.24897 -56.0438 21.5563 -6096 6 30.967 1.65521 30.3853 -24.4372 0.252197 19.6085 -6097 4 30.699 0.824835 30.0215 -2.04196 -23.8902 -26.6583 -6098 4 30.1085 1.94064 30.7387 6.28416 6.26069 6.0985 -6099 6 26.4053 36.4472 36.8445 23.7132 4.61357 6.55265 -6100 4 26.2095 35.8808 36.1068 -5.45287 -5.64468 -12.8873 -6101 4 27.3732 36.593 36.8324 -14.4493 2.44748 -3.93886 -6102 6 51.2993 10.0458 21.7014 24.6671 -30.2423 2.93053 -6103 4 50.7417 9.318 22.0589 9.26734 22.884 -6.07289 -6104 4 52.1551 9.59094 21.4448 -31.6711 18.7199 5.84467 -6105 6 52.4308 12.3792 23.2584 -6.42579 27.1004 22.8118 -6106 4 51.6946 13.0394 23.3088 16.6887 -7.91574 -6.77392 -6107 4 52.0327 11.5757 22.9611 -11.4365 -20.1199 -14.9439 -6108 6 9.99751 38.3699 20.6117 28.0449 -1.18219 -11.795 -6109 4 9.42862 38.2366 21.3654 -6.81781 0.619005 12.6857 -6110 4 10.9196 38.1916 20.8926 -11.789 -1.89114 -3.31064 -6111 6 22.7111 33.2651 0.632604 -8.26324 25.0772 17.5737 -6112 4 23.6702 33.3984 0.628432 0.752102 -10.2993 -4.51528 -6113 4 22.4939 32.4115 0.275412 2.14165 -18.6843 -11.1325 -6114 6 14.0859 40.8716 25.4956 -8.46488 1.55142 -11.4693 -6115 4 14.0599 40.7138 26.4427 12.1567 0.227551 5.06398 -6116 4 13.2623 40.45 25.1949 6.8133 8.32038 -2.55804 -6117 6 42.7734 15.0947 14.9538 14.4784 5.50426 -3.8277 -6118 4 43.0583 15.7694 14.2817 -8.42225 -24.0175 22.033 -6119 4 41.8405 15.2241 15.1238 -9.70916 3.613 0.791575 -6120 6 30.2327 7.231 8.54228 -3.22532 10.2874 -46.9304 -6121 4 30.2058 8.2102 8.45082 -0.363858 -13.9116 11.7844 -6122 4 30.4404 6.92219 9.39771 6.32383 2.81905 38.5597 -6123 6 3.37293 19.847 41.3038 28.0406 -0.792001 0.268463 -6124 4 3.19157 19.2836 40.5407 -0.0866071 4.98821 -2.30354 -6125 4 4.34764 20.0104 41.227 -24.6382 -4.50526 4.46777 -6126 6 8.87233 25.1482 17.2024 12.9182 -25.3276 -29.7935 -6127 4 8.99656 24.7585 16.2934 -10.9438 23.5455 20.5923 -6128 4 9.70028 24.8859 17.6216 -4.47076 0.166054 9.91948 -6129 6 9.34357 14.9539 22.0324 -26.1912 3.45279 3.87325 -6130 4 9.00509 14.8035 22.9321 4.97494 4.93375 -7.4516 -6131 4 10.1685 14.4775 21.9786 8.71262 0.391972 2.49596 -6132 6 2.03472 4.77693 20.8549 -5.0231 -16.4156 -4.2241 -6133 4 2.70086 5.4497 20.9192 18.9425 7.91266 2.94425 -6134 4 1.28907 5.15394 21.3146 -15.2358 3.90158 4.43282 -6135 6 18.286 7.04631 3.85489 -3.97091 0.415968 51.7005 -6136 4 18.7541 7.10917 3.04736 31.918 9.65669 -29.8899 -6137 4 18.8529 6.48913 4.44789 -12.6499 14.6692 -9.5202 -6138 6 17.0004 19.1661 19.8445 11.8294 -6.56912 -12.2376 -6139 4 17.7808 18.891 19.3473 0.445698 5.6808 3.33406 -6140 4 16.3387 18.5282 19.5337 -1.78106 12.0244 12.6463 -6141 6 4.30992 6.55322 21.357 27.1319 -4.11604 -15.0588 -6142 4 4.37542 6.91771 20.4543 -7.8574 5.76294 11.3657 -6143 4 5.24976 6.29093 21.5457 -28.1422 4.34799 0.417434 -6144 6 20.7778 36.9247 35.6618 12.7574 4.02765 2.49936 -6145 4 20.2864 37.0887 34.8562 -7.2468 0.0429553 -2.15645 -6146 4 20.2346 36.372 36.2389 -2.87094 1.27188 3.61263 -6147 6 4.73067 15.0203 31.2359 -10.2649 -12.7571 22.9725 -6148 4 4.37694 14.8342 32.1428 11.1861 -2.73027 -21.4712 -6149 4 4.72677 15.9733 31.1768 1.84417 11.2425 -7.2724 -6150 6 2.35535 1.23403 17.5726 17.2813 12.9738 -21.7174 -6151 4 3.03402 1.36527 16.8495 -17.2186 -13.1695 22.3246 -6152 4 1.92973 2.10387 17.6452 0.590267 -7.80147 9.6411 -6153 6 34.6252 31.5686 19.7984 -1.60729 -4.66139 0.568696 -6154 4 34.8929 31.9422 18.9439 4.49305 -5.18782 4.12596 -6155 4 34.4714 32.3271 20.3758 -2.9002 2.23803 -3.07041 -6156 6 24.1913 21.6089 13.5036 44.4004 0.328862 15.9674 -6157 4 25.0757 21.8297 13.9142 -30.8821 -6.11275 -18.7564 -6158 4 23.5519 22.0563 14.035 -11.4749 15.2668 7.23318 -6159 6 37.218 41.0972 5.69166 19.5034 -37.5651 -15.7416 -6160 4 37.88 41.7374 5.923 7.59407 13.6828 5.23653 -6161 4 36.3807 41.3769 5.99879 -24.6171 21.3167 5.70938 -6162 6 8.42841 7.99247 20.2345 27.9918 -33.0924 -23.0682 -6163 4 9.34968 8.06233 20.5347 -4.8675 5.92304 8.61954 -6164 4 7.93058 8.66586 20.633 -20.9635 39.4709 23.1164 -6165 6 14.934 18.8758 36.75 17.7625 18.3313 11.0559 -6166 4 14.0949 19.1945 36.41 0.856939 4.31409 -3.77921 -6167 4 15.6034 19.6084 36.7133 -18.5855 -12.9909 -4.44137 -6168 6 43.9791 40.6449 18.6524 7.41508 -0.428335 24.9958 -6169 4 43.9624 40.7544 17.7052 -3.16787 6.2189 -16.8328 -6170 4 44.8981 40.8188 18.9384 -9.62798 -9.77666 -5.30663 -6171 6 33.7986 32.259 37.3472 -15.5926 9.65631 -28.1821 -6172 4 34.0274 32.2295 36.4014 -5.19534 3.83485 15.8105 -6173 4 34.1945 31.4931 37.7276 18.2887 -12.3889 13.4194 -6174 6 5.09973 29.2834 24.0252 13.8314 -2.01249 29.2407 -6175 4 5.66693 29.5091 24.8044 -5.06459 -6.54793 -18.8628 -6176 4 4.76417 30.1245 23.7257 -5.49348 12.2693 -6.11875 -6177 6 33.6015 36.4179 10.971 30.294 2.53226 6.78363 -6178 4 32.7735 36.2836 10.5343 -15.5054 6.45725 -2.01925 -6179 4 33.4383 36.5424 11.9099 -7.56878 -2.98124 3.33663 -6180 6 28.3001 33.6166 13.1114 -3.16981 -41.1231 7.22112 -6181 4 27.986 33.7275 12.219 -4.10441 9.98298 -8.29397 -6182 4 28.0891 32.6746 13.2632 10.0083 14.4728 2.55385 -6183 6 6.1623 19.0624 24.2873 5.31394 -11.2621 -36.8053 -6184 4 5.95503 19.8074 24.8143 -4.51254 28.8134 22.7686 -6185 4 6.28788 18.3114 24.8476 4.1007 -18.6743 20.2695 -6186 6 28.4211 19.9362 1.86305 -4.43245 7.71948 8.08869 -6187 4 28.5604 19.4518 1.05094 6.94613 -11.0067 -8.65768 -6188 4 29.2593 20.0693 2.30859 5.46778 1.78077 -4.74455 -6189 6 42.0505 23.9714 9.55892 6.22877 26.0941 -5.00732 -6190 4 42.391 23.8165 10.4395 -2.03908 -8.00084 11.8727 -6191 4 41.7886 23.1541 9.15249 -7.7641 -22.6922 2.79783 -6192 6 43.5253 7.315 27.4414 4.48568 -18.9578 -0.168547 -6193 4 42.7359 7.07504 27.9388 -6.2009 1.74131 6.88183 -6194 4 43.2052 7.88335 26.7439 -2.31843 16.2411 -9.46916 -6195 6 20.4956 32.9945 9.25625 -63.2008 -2.41398 62.3431 -6196 4 19.7614 32.7323 9.96384 46.0698 -1.29529 -42.5223 -6197 4 20.3338 33.9485 9.24422 8.88758 3.29294 -12.4302 -6198 6 38.0318 35.2729 15.9427 -5.10059 -23.3836 -5.94715 -6199 4 37.3995 34.9842 15.2568 2.89047 3.01243 8.00796 -6200 4 37.9835 34.6007 16.6396 -2.13864 4.37071 -5.14357 -6201 6 47.5248 20.8808 3.95546 13.1177 31.1209 27.8573 -6202 4 48.0834 21.3954 3.36869 -6.69878 -8.89675 -13.1919 -6203 4 47.6052 21.4353 4.7772 -13.2785 -23.1226 -13.8569 -6204 6 10.9875 31.6892 41.4239 15.5099 5.40423 7.74084 -6205 4 11.658 31.8708 40.7529 -4.12469 -5.30401 -0.84079 -6206 4 10.1343 31.6927 40.9879 -7.96504 0.77506 -5.12071 -6207 6 43.245 12.6563 2.56138 15.9633 -17.8577 -2.60545 -6208 4 42.9226 12.9752 3.38765 -12.1061 12.2594 19.7928 -6209 4 43.9805 12.0851 2.8659 -6.2276 8.95994 -12.8364 -6210 6 49.4104 25.4124 21.1593 7.68799 -7.2912 5.83542 -6211 4 50.1422 25.2884 20.5387 -8.96396 0.548785 -4.3756 -6212 4 48.9554 24.5515 21.2297 -0.219253 8.20777 -2.75058 -6213 6 1.96484 34.1377 26.4635 6.42117 -7.58108 12.8955 -6214 4 2.78995 33.6488 26.6876 -20.6965 7.00883 -11.752 -6215 4 1.22498 33.5087 26.4121 8.61724 -1.18295 0.134997 -6216 6 17.1337 20.8362 36.6743 -37.6695 15.6036 21.8376 -6217 4 16.9634 21.7284 37.0778 2.65776 -21.0237 -14.9647 -6218 4 18.0617 20.7108 36.604 32.6572 -5.60583 -3.13187 -6219 6 36.5992 10.9735 3.70439 10.6975 8.82737 -5.2901 -6220 4 35.7369 11.4094 3.76988 -2.71865 -0.136466 14.5734 -6221 4 36.9547 10.7712 4.57736 -11.0261 -1.49358 9.11508 -6222 6 14.2213 20.6732 21.973 14.9521 39.3927 -42.8738 -6223 4 13.9206 20.2439 21.1689 -11.1282 -8.72354 1.45028 -6224 4 14.6851 21.4628 21.5779 -7.13343 -24.0966 22.8635 -6225 6 33.9052 12.2539 9.56536 64.6676 -19.1083 -72.943 -6226 4 34.3898 11.482 9.88615 -11.1791 5.59008 13.1859 -6227 4 33.2619 12.5422 10.1406 -48.1209 12.4396 55.8498 -6228 6 21.8075 41.4938 2.15247 -4.53434 0.170379 -15.7872 -6229 4 22.04 41.6038 1.2069 -3.47083 0.972349 16.0219 -6230 4 22.4007 40.8419 2.51679 12.4955 -1.6466 3.58022 -6231 6 20.9241 10.4413 14.2084 23.7182 11.537 17.3335 -6232 4 21.6155 10.8692 14.7979 -25.0251 -17.572 -17.464 -6233 4 20.772 9.54041 14.5736 6.4121 16.6732 -7.22543 -6234 6 6.25992 4.45494 24.6446 -20.993 10.5392 9.58783 -6235 4 6.70633 4.20365 23.8452 17.869 -10.7134 -15.0213 -6236 4 5.71116 3.71075 24.9084 -2.77077 -5.20552 -8.90983 -6237 6 50.776 14.5967 23.4784 31.7068 8.96229 10.5861 -6238 4 51.3012 15.0259 24.1918 -10.5702 -1.89466 -14.6802 -6239 4 49.902 14.4731 23.8252 -15.4415 -8.6063 7.51113 -6240 6 52.7906 13.9066 9.67243 -4.11462 48.2741 -4.64476 -6241 4 52.8606 13.0389 9.99278 3.823 -46.6932 12.5875 -6242 4 51.8698 14.0585 9.47707 -15.983 -0.946523 -10.048 -6243 6 9.04475 2.0467 29.9184 -38.5307 -30.621 -19.1189 -6244 4 9.46565 2.82007 30.2002 17.3321 39.2201 17.0183 -6245 4 8.08016 2.26538 29.8177 25.0495 -3.86709 2.38687 -6246 6 7.14389 29.9898 26.2407 4.70582 -42.771 12.4286 -6247 4 6.53112 30.404 26.8495 -5.08686 4.52864 3.1398 -6248 4 7.41427 29.1442 26.7142 -2.42767 26.6911 -17.7681 -6249 6 49.1638 41.7413 14.3375 -4.64089 27.4779 2.19815 -6250 4 49.5241 41.3828 13.5134 1.94418 -6.50091 1.47491 -6251 4 49.3811 0.802946 14.3236 2.14399 -30.2019 -5.07663 -6252 6 5.64888 3.82667 19.1906 -2.72189 -11.1411 26.1263 -6253 4 5.18678 3.36179 19.9258 5.23606 10.5823 -14.7259 -6254 4 5.05621 3.82399 18.4509 -7.60985 1.79477 -11.7277 -6255 6 9.32681 35.8274 24.8975 3.55565 13.5922 8.51546 -6256 4 10.2018 35.8152 24.4762 -3.06017 -4.39849 2.56743 -6257 4 9.46171 36.417 25.6586 -3.66837 1.49938 -3.23358 -6258 6 53.0285 29.7558 11.5499 -7.83487 -2.48558 9.64451 -6259 4 53.3653 30.4407 10.9686 7.5475 4.44921 -4.95089 -6260 4 52.7971 30.2083 12.3783 3.5824 -3.07517 -4.75195 -6261 6 22.6104 9.96627 5.67467 11.8622 1.90434 48.3765 -6262 4 23.3836 10.3266 6.15809 -8.36646 -10.9093 -7.81297 -6263 4 22.6398 10.3769 4.83333 -6.21393 7.91547 -32.804 -6264 6 39.5293 19.6134 2.67969 28.3515 9.20962 14.5311 -6265 4 38.5781 19.5068 2.58618 5.24604 -11.8744 -9.9137 -6266 4 40.0367 19.3939 1.87869 -17.6459 -1.04308 -3.70363 -6267 6 45.0742 35.5802 7.80399 12.9966 -1.00157 -13.6899 -6268 4 45.1073 36.2582 8.46111 4.45786 22.5875 10.9896 -6269 4 44.5296 34.9182 8.21469 -15.7495 -15.8794 0.100297 -6270 6 29.7829 14.2459 9.96531 -11.2509 -10.5838 -6.95263 -6271 4 30.0063 14.1556 9.0247 4.7074 -2.26926 1.20969 -6272 4 28.8478 13.9409 10.004 20.3358 11.6689 4.42407 -6273 6 29.2532 30.1489 21.8872 -22.7358 8.41186 19.7293 -6274 4 29.1261 30.8351 21.2312 3.02893 4.58934 -9.48892 -6275 4 30.0577 29.6729 21.7506 17.9631 -9.68935 -13.2514 -6276 6 11.1028 18.8149 6.56446 12.6172 11.1172 -5.75863 -6277 4 11.2898 19.7306 6.3073 -12.9819 2.38317 -1.53669 -6278 4 11.9922 18.4416 6.57196 0.724871 -8.7617 2.86424 -6279 6 13.403 39.1446 13.4748 19.5871 -11.9429 -30.0571 -6280 4 13.7697 39.8507 13.9939 7.8117 10.5151 13.4831 -6281 4 12.6292 38.8582 13.9386 -20.2152 -7.12839 8.32373 -6282 6 50.1432 12.9893 0.138872 33.4511 24.3017 64.4039 -6283 4 49.8497 12.6921 41.2405 -20.6967 -26.8999 -59.7452 -6284 4 50.7523 12.3231 0.503203 -9.52656 2.062 -3.94446 -6285 6 47.8312 31.3446 27.7846 -28.8076 12.8422 -13.2841 -6286 4 47.8833 31.94 28.5222 10.4006 4.03183 17.8143 -6287 4 46.9755 31.6479 27.4044 17.0933 -18.1054 -4.43643 -6288 6 27.7087 1.63781 7.50008 21.5285 -7.57238 -25.6841 -6289 4 26.9556 1.59549 8.05597 -25.0455 5.22958 17.9803 -6290 4 27.5166 0.963037 6.82134 -2.90509 7.89899 -0.0646572 -6291 6 54.8922 20.8 16.0331 4.1789 -41.4982 -7.93337 -6292 4 54.9282 20.9554 16.9716 0.186425 8.83729 15.9831 -6293 4 0.211633 19.8495 15.948 -9.91253 29.0383 -5.43741 -6294 6 37.4291 33.0056 34.4398 -14.0977 10.8622 -7.94924 -6295 4 37.2978 32.0826 34.6133 -1.58878 -21.6351 7.1631 -6296 4 36.5764 33.2755 34.0173 17.7258 4.45123 10.3439 -6297 6 19.5104 39.7742 6.7506 5.90241 -38.4201 -4.61078 -6298 4 19.1293 39.2182 6.01225 10.8403 19.9531 16.5545 -6299 4 19.9162 39.0938 7.35425 -12.9804 24.3225 -11.3083 -6300 6 32.4399 2.72699 8.06906 17.0773 23.4006 1.78158 -6301 4 32.9347 3.14941 8.81642 -19.9733 -16.2934 -9.37408 -6302 4 31.5531 2.49842 8.37658 0.516726 -6.41942 5.39598 -6303 6 12.9757 16.0915 4.06618 3.48233 -26.1302 -11.2272 -6304 4 12.5744 15.6527 4.83433 -0.695682 4.00385 -3.98901 -6305 4 13.3513 15.3473 3.55621 -4.30287 11.2057 5.6128 -6306 6 4.64677 29.9233 5.42983 -10.8182 14.2385 -56.8973 -6307 4 4.99957 30.1958 4.52107 -6.90737 -7.02982 36.161 -6308 4 3.86081 29.3683 5.18005 29.0195 11.7205 17.0104 -6309 6 29.7541 32.1122 24.0662 13.5325 13.0696 7.67536 -6310 4 30.657 32.2311 24.4313 -14.6232 -5.62961 -5.85099 -6311 4 29.8358 31.5529 23.3009 -2.99915 -14.1964 -7.88188 -6312 6 11.8689 30.6971 33.4711 -8.01032 -39.2081 28.7873 -6313 4 11.8961 29.8478 34.0479 -0.904256 41.1124 -29.4381 -6314 4 12.7288 30.7703 33.0546 6.62137 -3.78113 1.33903 -6315 6 17.3676 40.4123 27.3051 45.9752 30.8726 -27.1152 -6316 4 17.3095 41.3718 27.4557 -2.78012 -6.90788 -0.219066 -6317 4 16.6513 39.9873 27.6906 -54.0346 -15.2197 27.4879 -6318 6 8.66734 4.89901 8.93063 6.14116 -5.58058 -4.6479 -6319 4 8.35347 5.40804 8.18272 -1.2331 1.82325 -6.13974 -6320 4 8.16334 5.22925 9.67691 0.199365 1.34734 7.84993 -6321 6 39.5604 17.6833 9.57201 22.5105 -50.1639 -23.667 -6322 4 39.2658 17.6048 10.464 -10.5204 8.51393 23.2154 -6323 4 39.725 16.7168 9.31019 -10.6666 45.7312 -1.86495 -6324 6 31.4955 30.1755 28.5516 10.628 -19.507 17.1882 -6325 4 32.3525 30.3948 28.1778 -6.71462 8.32315 -8.11857 -6326 4 31.74 29.3729 29.0438 -14.9082 5.37925 -0.357203 -6327 6 52.6685 19.2672 40.0663 9.25056 16.4026 -20.0757 -6328 4 53.0106 18.7322 39.321 -9.61724 -4.6138 17.4516 -6329 4 53.0677 20.1385 39.8955 -5.74465 0.792691 -1.74468 -6330 6 3.24164 7.81666 9.85998 28.0429 9.66948 1.15728 -6331 4 3.83019 8.53432 10.2304 -23.9275 -17.8293 -12.7584 -6332 4 3.84853 7.29279 9.3074 -9.38214 5.4782 3.90821 -6333 6 23.129 35.218 35.5945 -25.4929 1.01472 15.9258 -6334 4 23.7784 35.3391 34.9359 33.2897 3.00284 -24.4901 -6335 4 22.5015 35.9398 35.4197 -4.85807 -5.03855 8.29984 -6336 6 19.51 14.0653 20.8221 -35.7596 -3.44758 -1.61502 -6337 4 19.8587 14.4985 21.6011 13.4146 6.44294 7.16022 -6338 4 18.5274 14.0852 20.9637 18.4505 -1.93413 -5.69736 -6339 6 23.6205 15.8624 24.0207 6.44012 -27.6666 -1.73497 -6340 4 23.7023 16.8084 24.0387 5.71305 22.1977 -2.17526 -6341 4 24.4604 15.4749 23.6823 -15.4387 15.2983 3.34328 -6342 6 0.280487 30.496 6.10097 2.10248 14.5258 38.6463 -6343 4 54.969 30.1752 5.28655 -5.78718 -18.1599 -43.8305 -6344 4 54.4568 30.8162 6.51538 2.11893 2.60892 6.09244 -6345 6 4.88818 13.213 29.1211 -10.1066 -44.834 -24.7823 -6346 4 4.81121 13.8494 29.7943 -5.77674 34.7781 35.8081 -6347 4 5.65875 13.4519 28.6173 14.302 5.76116 -10.624 -6348 6 54.2113 27.2762 19.1921 -15.5686 -30.3542 31.9917 -6349 4 0.068746 27.3681 19.6083 11.8738 0.793184 4.88761 -6350 4 54.2438 27.8077 18.4285 0.565084 22.1088 -37.313 -6351 6 13.9147 35.7477 9.19539 -9.45761 -42.0549 -30.4782 -6352 4 13.6498 35.0288 8.53341 12.0253 23.1831 27.3793 -6353 4 13.9217 36.5134 8.63033 3.91359 16.7787 -6.83247 -6354 6 5.91895 31.9062 18.8199 -10.5522 26.6577 -12.1166 -6355 4 5.59368 32.8276 18.7738 -3.70357 -9.82177 15.0022 -6356 4 6.3357 31.8271 17.9661 5.53766 -12.0386 -9.76018 -6357 6 5.80079 28.8629 9.48582 -4.23387 2.66619 -7.91216 -6358 4 5.1492 29.3316 10.0156 -4.194 3.81529 3.65919 -6359 4 5.26808 28.2356 8.96551 5.75879 5.11243 0.385299 -6360 6 40.1186 6.06288 9.7252 27.6823 -14.9678 -34.8134 -6361 4 40.0604 6.61837 8.91786 -4.97866 -6.72317 19.9534 -6362 4 40.8451 5.41953 9.46609 -26.5422 19.2978 14.9684 -6363 6 20.3249 13.4665 41.4109 48.5393 0.491453 -34.6424 -6364 4 21.248 13.7047 41.7262 -35.6043 -9.97545 -2.58991 -6365 4 20.4078 13.625 40.4256 -17.6073 -2.89865 23.6593 -6366 6 14.4355 21.7431 27.3521 26.8888 -5.93952 12.1752 -6367 4 15.3929 21.7238 27.5426 -15.4302 4.65814 3.66232 -6368 4 14.4086 21.5632 26.4128 -6.38145 3.02673 -3.91912 -6369 6 38.7552 1.80385 30.0529 11.0268 -28.3612 -27.359 -6370 4 38.4475 1.96331 30.9218 -11.1335 10.8767 32.3314 -6371 4 38.864 2.66369 29.6567 5.01485 14.1269 -3.82072 -6372 6 5.6038 10.8537 14.1812 -8.02182 -19.6512 10.0037 -6373 4 4.967 11.5707 14.1035 -3.71772 1.30399 -2.93081 -6374 4 5.11243 10.0991 14.6 11.6474 17.9462 -13.8385 -6375 6 45.4185 36.7135 27.9228 -18.8199 18.417 -42.2307 -6376 4 46.0687 36.7087 28.6222 8.21134 6.27257 3.16342 -6377 4 45.7172 37.2784 27.1471 -3.80026 -24.227 32.4306 -6378 6 54.0799 35.0377 20.3974 -0.144446 0.236923 -11.8112 -6379 4 53.8476 34.1116 20.536 0.519878 -4.41527 -2.37245 -6380 4 53.9532 35.2077 19.4441 0.866973 -0.817495 13.7238 -6381 6 42.0671 14.221 28.4749 -2.16655 -3.30611 3.54679 -6382 4 41.9442 13.9043 29.3971 9.00113 8.16851 -11.079 -6383 4 42.9986 14.4434 28.31 -2.56617 -4.72525 9.98454 -6384 6 34.845 7.68802 26.7053 1.50556 20.2543 7.34306 -6385 4 35.7046 7.39142 27.0344 -1.60005 -9.47728 3.59716 -6386 4 34.4934 7.05976 26.0702 4.4346 -10.8207 -3.70702 -6387 6 49.6605 30.7141 23.8514 -28.5275 -6.56067 -11.9374 -6388 4 50.4604 31.1934 23.8565 34.1351 17.5516 -0.640456 -6389 4 49.8146 29.9659 24.4072 5.37992 -19.8924 15.651 -6390 6 50.8948 7.80148 14.1671 21.5777 -12.9452 34.2787 -6391 4 50.8247 6.96775 13.7105 -4.99079 -12.0182 -18.7136 -6392 4 50.5655 8.51894 13.6572 -15.7049 17.9748 -24.3233 -6393 6 4.26893 39.4826 27.8512 8.9926 -8.51629 -1.47833 -6394 4 3.65831 40.2241 27.8513 -3.04259 7.34368 5.94949 -6395 4 4.00328 38.958 27.1013 -12.9816 -10.5728 -11.1653 -6396 6 8.75177 32.8341 8.22283 -21.5639 -30.1985 -34.1316 -6397 4 8.2383 32.1284 7.72694 10.6374 17.547 21.6449 -6398 4 8.83279 33.5372 7.56693 3.76401 9.53239 7.06969 -6399 6 52.9594 25.4882 9.38297 -25.0802 50.1357 20.0056 -6400 4 51.9882 25.4292 9.65119 35.7509 1.27265 -17.7678 -6401 4 53.158 26.4759 9.49827 -6.53976 -44.9947 -5.62964 -6402 6 29.5661 36.7256 19.4603 5.44621 -17.3757 32.4066 -6403 4 29.5786 37.3961 18.7906 9.88328 7.74732 -15.4263 -6404 4 30.4565 36.6309 19.8726 -14.3545 4.38723 -10.5986 -6405 6 52.3236 36.1013 25.1169 17.8415 -25.8683 -35.0149 -6406 4 52.9656 35.7372 25.71 20.0999 5.67458 7.00157 -6407 4 51.6595 36.4261 25.6714 -35.904 19.3861 23.0835 -6408 6 21.182 15.7103 31.1872 -18.8583 3.19523 -20.0756 -6409 4 20.6533 16.2005 30.5215 19.2403 -4.60119 13.454 -6410 4 20.518 15.2243 31.6931 2.46505 1.20146 2.10658 -6411 6 10.6569 22.4337 39.4531 2.51655 -26.4213 -37.4968 -6412 4 10.8327 22.4219 38.4645 -4.29248 9.16844 28.2769 -6413 4 10.2506 21.5589 39.6181 7.08653 12.2011 0.686531 -6414 6 25.1113 11.6729 22.7164 -12.9971 -0.576423 -18.0399 -6415 4 25.1382 11.4787 23.6279 21.2779 0.00518046 39.517 -6416 4 24.1824 11.5118 22.5586 2.84555 -0.272219 -17.8246 -6417 6 31.7896 10.4703 2.90217 -23.2712 -10.1944 -9.79051 -6418 4 32.6146 10.7499 3.28348 13.8778 6.97942 -8.99307 -6419 4 31.8394 10.4464 1.92418 10.0551 5.29594 18.2662 -6420 6 52.4849 36.4361 22.1663 -9.62786 -33.6069 5.21212 -6421 4 53.146 36.0606 21.5474 -12.5852 0.946736 4.3316 -6422 4 52.0694 35.6392 22.6209 17.7505 30.3514 -16.202 -6423 6 46.2093 40.0329 26.9877 0.0297183 29.9961 33.6049 -6424 4 46.4751 39.2742 26.5126 9.55695 -26.8643 -22.4205 -6425 4 45.9048 40.7092 26.3771 -3.76152 -2.91476 -3.34389 -6426 6 24.0885 36.7218 39.1011 7.12362 -3.16907 -4.80429 -6427 4 23.5999 35.9078 38.9667 11.8985 -11.6148 -5.9332 -6428 4 23.4559 37.2234 39.5891 -11.7402 16.6095 17.3029 -6429 6 22.3514 7.42547 31.8169 -35.2707 -41.8068 15.3628 -6430 4 22.2213 8.33277 32.0647 5.94025 21.3422 4.40196 -6431 4 21.6465 6.92073 32.3398 32.1745 21.6054 -24.7594 -6432 6 14.3502 18.3597 4.09728 -2.0055 -9.38358 23.348 -6433 4 14.1099 17.4219 3.93107 -0.92654 19.6042 10.3569 -6434 4 14.0726 18.5364 5.03654 13.0175 -10.3464 -23.9346 -6435 6 27.3175 38.46 0.124188 33.1007 -9.911 1.68747 -6436 4 26.9395 39.2806 0.463932 -4.88512 2.40457 5.81864 -6437 4 28.2608 38.413 0.45438 -35.2324 2.96259 -2.16122 -6438 6 18.6695 0.162292 12.2239 -43.166 1.81748 26.3235 -6439 4 17.7303 0.262878 12.5713 26.4571 2.30278 -22.2908 -6440 4 18.9433 41.3202 12.7499 8.63834 -11.46 6.42912 -6441 6 49.423 24.9792 25.3382 20.605 1.42964 -0.346179 -6442 4 48.5484 24.7002 25.6009 -12.613 -0.556076 -3.92373 -6443 4 49.3508 25.8032 24.8352 -9.8769 -5.62219 -3.2466 -6444 6 52.0685 20.2858 15.7446 -45.9435 -8.75518 14.7384 -6445 4 52.9731 20.5149 15.783 39.268 6.79994 2.42829 -6446 4 51.7449 20.2597 16.6676 4.81444 3.79951 -9.92674 -6447 6 49.6576 15.6472 38.4942 19.425 -17.6129 -0.00729052 -6448 4 49.2099 16.0165 37.7231 -6.98596 1.36616 -1.50856 -6449 4 49.5102 16.1958 39.2633 -14.7214 13.7889 5.58845 -6450 6 15.9211 23.7235 13.4193 23.3289 -36.8815 11.3263 -6451 4 16.506 23.7025 14.2147 -19.633 8.70021 -19.3267 -6452 4 15.5217 24.5725 13.2813 -7.62789 19.6624 11.7876 -6453 6 14.3566 29.1635 14.3074 -12.0826 22.9902 -11.8551 -6454 4 14.1263 29.6193 13.4563 6.10678 -19.1115 21.2229 -6455 4 14.1254 29.8374 14.9735 4.9154 -5.66101 -4.10969 -6456 6 30.4264 19.8612 16.8883 21.8822 -42.1222 -1.02119 -6457 4 30.7186 19.5182 17.7453 7.89699 4.38367 -1.56912 -6458 4 29.8579 20.5689 17.0557 -25.7709 36.069 4.20145 -6459 6 21.3137 21.0352 23.1207 17.1515 -0.95565 24.203 -6460 4 22.2175 21.149 23.495 -16.5785 2.35003 -9.75668 -6461 4 20.7278 21.0809 23.8918 1.9436 3.71589 -4.02445 -6462 6 32.3543 0.425745 25.2542 2.91189 -3.53517 -15.1456 -6463 4 32.2281 0.339162 24.2978 10.7775 -1.18886 4.59452 -6464 4 31.5305 0.792307 25.5362 -21.0885 6.89421 14.2132 -6465 6 26.144 32.4145 27.5224 1.5207 15.2147 0.716215 -6466 4 25.5792 33.1636 27.3089 1.00017 8.92672 2.49827 -6467 4 25.8737 31.7446 26.908 1.40169 -15.6227 -12.5261 -6468 6 31.6924 23.0038 41.4488 2.9891 4.25247 18.5975 -6469 4 32.5817 22.7219 41.7427 -10.6129 2.19465 -7.80737 -6470 4 31.0787 22.7203 0.234806 2.54762 2.31931 -6.22567 -6471 6 54.3675 17.8383 10.7129 6.79577 23.0573 52.4548 -6472 4 53.55 18.2477 10.4428 -14.1319 6.62767 -11.4304 -6473 4 54.6119 17.1874 10.0964 4.54612 -26.2874 -33.1105 -6474 6 15.4111 28.5567 8.624 -23.5209 17.7221 -14.2225 -6475 4 14.7074 29.0083 8.07604 23.4242 -18.2482 9.63627 -6476 4 15.9053 27.9212 8.07642 -10.4486 8.35345 -4.07335 -6477 6 21.923 22.3267 27.6697 4.39763 -15.072 3.90508 -6478 4 22.0757 23.261 27.7591 9.36727 14.8743 -6.39222 -6479 4 22.0153 22.013 28.5729 -4.02641 -8.91923 4.38679 -6480 6 2.936 17.0367 8.13301 26.8737 -0.816539 -9.93732 -6481 4 3.80704 17.1417 7.69888 -17.5309 -13.2134 -6.39661 -6482 4 2.90872 17.8246 8.6543 -8.08771 15.2208 15.3377 -6483 6 27.578 18.2783 3.98106 42.3665 -21.0645 -7.59535 -6484 4 26.9838 18.9866 3.87461 -35.9411 25.5305 -3.32845 -6485 4 28.3853 18.6252 3.56495 -11.0807 -10.9366 8.58166 -6486 6 24.7671 24.5333 8.4671 -3.55267 7.94183 -11.8318 -6487 4 25.0347 23.6359 8.24775 3.17664 -3.45343 1.13667 -6488 4 24.5725 24.5372 9.40731 3.34714 4.39373 0.466573 -6489 6 41.9868 30.4684 13.7801 28.6364 -21.7839 2.09937 -6490 4 42.9472 30.4515 13.6527 -5.43777 20.4489 -0.76134 -6491 4 41.8419 29.5153 13.705 -23.7897 6.87836 6.63004 -6492 6 15.6883 34.6775 41.5701 28.3539 0.757195 5.77675 -6493 4 16.4499 35.2822 41.5481 -1.40988 -1.74654 9.10263 -6494 4 14.9914 35.2483 41.869 -21.9895 7.57474 1.73196 -6495 6 11.1473 19.7636 40.5906 -7.01786 -3.24743 -12.0486 -6496 4 12.0915 19.8265 40.3679 -7.75233 -10.0339 3.8807 -6497 4 10.7912 18.9088 40.243 10.6872 10.1147 9.9033 -6498 6 47.4955 34.5311 14.2936 14.7321 -31.661 -1.66099 -6499 4 46.9342 35.3117 14.2317 -6.87541 2.2103 -19.2779 -6500 4 47.4978 33.9137 13.4978 -3.14061 27.4792 16.9676 -6501 6 12.3981 26.9866 28.4861 26.5251 -74.1409 -7.08463 -6502 4 13.226 26.8461 29.0045 -10.1246 11.0422 -0.548558 -6503 4 12.3843 26.0988 27.9797 -6.45597 45.1087 15.272 -6504 6 27.6352 16.207 39.8297 -11.2321 14.8168 6.13397 -6505 4 27.2166 15.4175 40.1567 -13.0977 -6.13948 14.8525 -6506 4 28.2209 15.8539 39.184 23.7477 -3.37658 -20.6816 -6507 6 33.4012 31.2187 27.2758 -9.34358 5.5086 -22.6345 -6508 4 34.125 31.7676 27.5967 0.31405 7.14405 -9.79506 -6509 4 32.8978 31.7031 26.5666 21.3968 -7.09575 17.214 -6510 6 39.0983 39.5786 31.9234 0.802497 -2.15341 -0.194752 -6511 4 38.8245 39.6381 30.9898 -0.836727 0.773065 10.2743 -6512 4 38.5517 40.2102 32.4207 8.13236 -5.11153 -2.10971 -6513 6 22.8875 16.5662 19.9556 -18.6429 -47.4181 0.677292 -6514 4 23.2714 15.7467 20.3471 4.73069 19.3315 1.98369 -6515 4 22.0725 16.1814 19.5628 10.6014 14.9969 -2.71875 -6516 6 23.9725 21.8734 10.5896 -27.2099 14.1239 -19.8382 -6517 4 22.9807 21.8764 10.5048 23.1264 -0.860286 11.7265 -6518 4 24.1883 21.166 11.1844 -1.51334 -13.3572 20.4185 -6519 6 40.1791 25.4384 2.79385 3.27033 10.4385 -27.7191 -6520 4 40.1215 24.9503 3.60378 -1.57927 -2.0951 21.761 -6521 4 39.8421 26.3422 2.89187 -4.34677 -6.39915 11.9951 -6522 6 15.0222 19.7637 9.4145 -47.1416 28.5942 15.5409 -6523 4 14.7277 20.7258 9.2944 13.9352 -33.0223 -5.4956 -6524 4 14.1981 19.3167 9.80349 37.3596 11.4933 -12.2096 -6525 6 7.16734 24.8761 0.122492 -38.9593 -14.3052 4.78001 -6526 4 7.92262 24.7355 41.4818 28.9246 2.82935 -8.29154 -6527 4 7.37325 25.3267 0.937782 12.1222 2.94845 5.10402 -6528 6 43.395 10.8961 31.3295 35.6095 27.14 14.9602 -6529 4 43.8689 11.0333 30.4778 -14.9331 -12.4968 13.4948 -6530 4 44.125 11.0026 32.0067 -24.5429 -5.74221 -22.764 -6531 6 13.8447 19.0699 27.8622 -3.35019 15.2359 -6.83255 -6532 4 12.9833 18.7163 28.0985 -4.55464 1.4506 5.93475 -6533 4 13.7874 20.0538 27.8435 3.60016 -14.5834 0.921784 -6534 6 3.48728 19.5892 9.61273 -55.7314 7.48447 -10.4955 -6535 4 2.69835 20.0905 9.96963 22.9021 -19.0673 -4.76373 -6536 4 4.2501 19.9102 10.0538 23.4289 5.03115 15.3445 -6537 6 51.0169 19.4212 7.7195 26.3048 39.1054 -53.7154 -6538 4 50.748 20.2575 7.21364 -2.7273 -32.3506 28.7892 -6539 4 51.8579 19.2204 7.21263 -29.2082 -7.0208 18.9647 -6540 6 42.2149 2.6091 10.4112 25.8935 -20.0624 -18.8025 -6541 4 43.1623 2.45904 10.6444 -24.152 11.2038 4.82319 -6542 4 42.1853 2.33112 9.4647 -3.80011 10.6068 21.7004 -6543 6 30.7928 6.43901 35.1986 -21.6247 -20.8821 1.11778 -6544 4 29.8295 6.39304 35.3716 10.0359 5.79706 -2.44011 -6545 4 31.0478 5.50645 35.0814 0.649811 9.90023 -1.69835 -6546 6 52.8722 36.96 18.5947 9.01539 9.27494 -7.55423 -6547 4 52.0657 36.4448 18.5061 -12.9065 3.13675 2.3407 -6548 4 52.6935 37.8522 18.2226 2.03776 -15.609 7.12003 -6549 6 44.2018 6.29599 1.04883 9.29405 17.1768 7.51252 -6550 4 44.5044 7.06671 1.58929 -4.49779 -17.4812 -0.431191 -6551 4 44.952 6.10526 0.487985 -0.115844 -2.61588 -3.46335 -6552 6 42.1326 38.6047 31.1849 18.5327 -13.3283 33.8135 -6553 4 41.7834 38.9864 30.4106 -14.9936 10.8543 -35.8121 -6554 4 41.4904 38.8324 31.8627 -0.641051 1.33351 1.93 -6555 6 43.7219 12.8013 9.05519 -6.282 7.91343 -40.7352 -6556 4 43.3171 13.69 8.87718 10.3632 -22.6116 8.3507 -6557 4 43.9578 12.415 8.15014 1.61383 14.3586 37.3488 -6558 6 13.4062 0.438838 6.51561 -30.6084 29.4042 -0.600484 -6559 4 12.9719 1.14899 7.05573 20.0807 -17.3818 -8.1595 -6560 4 13.3782 0.782754 5.59696 2.59294 -3.03922 8.63079 -6561 6 16.1217 13.2907 10.2805 -3.10591 -25.3511 -12.454 -6562 4 16.8946 12.7568 10.5076 8.02861 4.25978 2.86397 -6563 4 15.5299 12.6092 9.88546 -0.135156 17.9383 7.81515 -6564 6 1.59113 8.48217 4.69745 0.410151 -22.2633 16.3582 -6565 4 1.97054 9.1194 4.11301 8.92831 16.113 -22.7699 -6566 4 2.26765 8.43533 5.38895 -6.97239 3.0759 6.50405 -6567 6 37.2935 1.72102 10.5172 -13.7439 -9.21578 15.0824 -6568 4 37.1042 2.64553 10.595 10.0955 20.4226 -13.0857 -6569 4 36.8105 1.41855 11.2983 8.13599 -13.5394 -0.658926 -6570 6 53.8411 9.88961 17.6933 -45.7386 -38.9159 3.57486 -6571 4 54.5353 10.0399 17.0846 27.4782 6.59889 -23.5339 -6572 4 53.3721 9.08338 17.329 10.482 22.3983 14.0606 -6573 6 45.4787 30.6173 15.8038 -24.3966 -4.27047 13.1326 -6574 4 44.7717 31.1876 16.1963 22.3351 -9.42651 -10.1125 -6575 4 45.1907 29.6979 15.9324 6.84487 10.052 -2.21901 -6576 6 39.9241 16.6394 33.8426 -26.8877 -6.37158 -14.218 -6577 4 39.1549 17.2016 33.5476 23.291 -18.1751 3.42158 -6578 4 39.818 15.753 33.3934 2.94846 26.4583 15.0268 -6579 6 32.8532 24.7638 27.9368 9.55773 21.8346 -14.3088 -6580 4 33.6229 25.0593 28.4772 -14.6217 4.84572 -15.4057 -6581 4 32.6055 25.4822 27.2751 14.9958 -18.2832 35.5187 -6582 6 7.86628 31.6164 24.1091 22.2934 14.9204 62.1634 -6583 4 7.77595 30.8628 24.7489 -5.82572 16.0022 -25.8365 -6584 4 8.17309 32.3545 24.746 -24.9312 -26.1857 -42.8493 -6585 6 43.5324 41.3356 15.8165 16.5067 -5.02973 0.188395 -6586 4 43.1944 0.320073 15.7896 -5.69638 5.43212 -4.38793 -6587 4 44.429 41.3992 15.443 -10.6291 -2.88383 0.315207 -6588 6 20.021 29.5505 33.1902 25.0419 -7.98688 14.3875 -6589 4 20.8911 29.4069 33.5992 2.6372 -12.3274 -8.42754 -6590 4 19.6576 30.1636 33.8147 -14.9588 14.7065 -0.197692 -6591 6 43.4056 21.4569 18.6265 10.2156 -2.1017 15.5441 -6592 4 43.0498 21.3696 19.5313 -0.699705 -7.60676 -10.3888 -6593 4 42.9844 20.831 18.0298 -12.2248 -1.50447 0.773582 -6594 6 3.43117 19.1215 18.408 34.3393 4.70286 11.768 -6595 4 3.22621 20.0564 18.4267 -2.18643 4.81974 -5.59269 -6596 4 2.60088 18.6799 18.3703 -20.3233 -14.3491 -1.28903 -6597 6 41.6742 38.1112 16.3299 0.384784 -42.0766 -46.2559 -6598 4 41.8939 37.3404 15.6708 -9.75075 44.1094 34.3099 -6599 4 42.3403 38.1083 17.0131 5.25517 -2.87066 6.28124 -6600 6 7.56339 36.3915 10.5048 -18.8567 -13.4705 -13.5944 -6601 4 6.70677 36.1596 10.0967 9.18231 15.0261 0.193132 -6602 4 7.92251 35.493 10.5558 6.04756 10.3771 12.1048 -6603 6 36.2642 19.1103 34.8187 -40.4108 -29.7457 -43.4097 -6604 4 35.4719 19.3187 34.2477 20.3247 -4.92751 27.2967 -6605 4 36.4213 19.8813 35.3193 7.80254 33.8099 20.7293 -6606 6 53.576 24.9483 12.6399 1.20561 -0.517111 -17.326 -6607 4 53.6619 25.9414 12.669 8.79141 -29.2645 -7.24265 -6608 4 53.913 24.5623 11.7782 -4.09912 18.2899 28.1509 -6609 6 31.6824 10.4618 21.0892 -21.9557 -25.3726 -8.81809 -6610 4 31.4281 9.67391 21.5915 5.84781 10.5911 6.7189 -6611 4 30.8909 10.5838 20.5303 11.506 8.60894 0.332243 -6612 6 18.1093 28.7861 17.1823 13.2379 18.2354 -13.1758 -6613 4 19.074 28.7105 16.9739 -24.5165 5.38082 5.29014 -6614 4 17.7652 29.607 16.728 11.5472 -26.6353 13.0333 -6615 6 21.6834 18.2239 36.88 17.2587 0.811675 -5.67627 -6616 4 22.5671 18.027 36.4721 -27.7349 -1.55215 19.1593 -6617 4 21.6367 17.7543 37.7464 -1.70499 5.95625 -12.509 -6618 6 25.0551 19.0348 34.2287 -62.1041 -5.07763 23.2016 -6619 4 24.7663 18.3443 34.8719 5.43786 16.9757 -10.9409 -6620 4 25.8827 18.7578 33.9618 64.2031 -27.8273 -22.1538 -6621 6 15.5709 13.019 5.5539 0.00735057 -17.6807 20.5563 -6622 4 15.9927 13.3293 6.36292 0.0692085 12.4919 -5.39058 -6623 4 15.4491 12.0681 5.73828 -2.05735 13.2604 -17.7033 -6624 6 54.47 41.6402 14.7959 12.609 -13.6787 23.2741 -6625 4 54.8097 41.4531 15.6947 -1.45983 11.4249 -10.5768 -6626 4 53.7709 40.9948 14.7271 -15.6812 0.146288 -8.92901 -6627 6 1.6639 26.4809 31.3827 12.672 -25.15 69.1319 -6628 4 2.55491 26.3764 31.7735 -12.447 -0.333387 -5.00094 -6629 4 1.81595 26.6127 30.4938 10.6163 16.8649 -70.5286 -6630 6 32.3417 37.2868 29.6843 -28.8191 13.9029 5.49332 -6631 4 31.5776 37.8992 29.8843 22.0104 -18.6347 -4.04342 -6632 4 33.1171 37.6855 30.0945 4.79121 1.59444 1.77014 -6633 6 52.7104 21.0422 22.8867 -25.9211 15.4876 17.6965 -6634 4 51.8895 21.5407 22.5959 27.9099 -16.7396 2.24416 -6635 4 53.1785 20.6742 22.1421 1.33026 -7.16251 -14.9349 -6636 6 32.7465 28.5808 40.5193 19.5614 -2.95666 4.13778 -6637 4 32.1272 29.2507 40.2236 -19.1805 -2.02865 5.11045 -6638 4 32.5793 28.3106 41.4408 -7.78706 5.87783 -13.0149 -6639 6 23.6078 32.0654 16.3528 6.52471 10.7856 29.7964 -6640 4 24.3701 32.0729 16.9793 -11.8963 -10.2614 -20.8491 -6641 4 22.8856 32.382 16.9256 -1.99185 -7.37994 -15.8659 -6642 6 37.5296 9.17182 29.9714 -32.9897 5.30306 10.5453 -6643 4 36.7716 8.86544 30.5111 15.5785 -5.70066 -5.7121 -6644 4 37.1221 9.9689 29.5744 15.1662 -5.45151 -1.53858 -6645 6 2.26386 24.3835 14.5546 6.71022 -7.72281 -24.2479 -6646 4 1.85963 24.0133 15.3587 -6.19133 3.33276 -9.20692 -6647 4 2.05254 23.8227 13.7642 -0.610841 12.6744 29.5344 -6648 6 27.3686 28.7935 24.7702 8.50672 -13.2399 -34.495 -6649 4 27.2338 28.4442 25.6457 -6.20833 -8.14759 12.6395 -6650 4 27.3624 28.0447 24.1031 3.25167 21.2409 25.246 -6651 6 16.785 2.54959 14.3094 -6.20571 44.0359 18.8502 -6652 4 17.7332 2.53792 14.3228 12.8455 -14.2273 -3.64568 -6653 4 16.4133 1.8101 13.8617 -1.35631 -25.1723 -17.3636 -6654 6 21.8048 39.8028 36.8143 34.4281 41.1875 6.43987 -6655 4 22.7768 39.6281 36.9504 -24.2083 -5.20947 -5.56999 -6656 4 21.4132 39.0119 36.5213 -11.0202 -42.2818 -12.3994 -6657 6 14.0639 6.48367 41.5586 -1.33856 -25.5903 -39.7582 -6658 4 14.9412 6.10051 41.3922 2.86672 3.38346 15.7648 -6659 4 14.0719 7.05039 0.399753 4.3465 12.2327 22.8772 -6660 6 14.5548 16.5075 9.32956 22.0841 -14.7784 -21.2506 -6661 4 15.3586 16.5914 9.87503 -6.36199 2.72911 -6.08794 -6662 4 13.8899 17.0883 9.65711 -8.71884 14.1475 23.1102 -6663 6 8.67066 23.4815 30.5556 -44.0195 -7.59097 13.7496 -6664 4 9.49671 23.6557 30.1334 33.8338 1.75787 0.0184994 -6665 4 8.69311 23.4014 31.5307 16.0679 1.7618 -7.5699 -6666 6 37.6567 2.07706 19.9993 -10.7882 4.4912 14.9507 -6667 4 36.977 2.26584 19.3592 -1.31755 -8.36894 -24.369 -6668 4 37.311 2.65872 20.6865 17.7477 -2.01295 10.0374 -6669 6 42.7201 7.55732 8.02256 37.7013 -31.8103 68.6738 -6670 4 43.2078 7.90139 7.31041 13.9641 18.3531 -33.1003 -6671 4 43.4713 7.36984 8.74143 -54.3005 13.1784 -34.8973 -6672 6 38.5678 29.6657 6.85728 10.4727 -7.97498 12.0381 -6673 4 38.5138 29.2192 7.70857 5.95943 6.40388 2.63109 -6674 4 37.7242 29.471 6.47402 -15.8477 4.38345 -15.5494 -6675 6 42.5297 15.7017 39.7864 -1.2311 2.72873 2.24862 -6676 4 42.7877 16.6334 39.6476 -7.55712 -4.9727 -7.52807 -6677 4 42.0746 15.3358 38.9963 17.4435 12.5166 7.69263 -6678 6 19.8571 7.43592 22.0545 -24.1472 -5.51637 33.4113 -6679 4 19.2244 8.12179 21.7601 9.35088 -5.78158 -2.10146 -6680 4 19.4596 7.11536 22.9248 14.2781 17.6372 -34.9907 -6681 6 27.4149 3.22069 12.5516 40.9266 14.4549 -35.8463 -6682 4 28.3021 3.29229 12.0821 -30.0356 5.19144 18.8294 -6683 4 27.3767 2.28812 12.7581 -5.67627 -4.82192 6.74426 -6684 6 34.4116 6.50186 34.3661 -21.9879 -4.07114 7.78674 -6685 4 33.6675 7.13398 34.4265 8.52018 -4.33452 -1.60522 -6686 4 34.0848 5.70903 34.842 8.55338 12.1797 -0.556276 -6687 6 9.89342 27.9558 39.7643 36.6491 -8.46867 13.0669 -6688 4 10.8456 28.0225 40.104 -41.9626 -4.51635 -15.7261 -6689 4 9.67004 28.8098 39.3873 2.34979 10.3628 -2.65954 -6690 6 50.5619 22.115 6.39208 17.1303 26.4748 31.0688 -6691 4 51.4904 22.4109 6.45725 -8.74694 -11.3909 -7.00891 -6692 4 50.1939 22.6078 7.15954 -8.62199 -11.7106 -16.757 -6693 6 47.1151 11.4881 30.0373 19.0993 -20.4412 31.5796 -6694 4 47.2481 10.8506 30.7795 8.25865 21.4973 -13.9376 -6695 4 46.3269 11.1564 29.6474 -26.9131 -5.13028 -17.9745 -6696 6 25.9416 28.4741 9.79918 -11.6773 -32.55 32.2578 -6697 4 26.8348 28.2861 10.1548 -13.4597 2.20587 -7.83095 -6698 4 25.3328 27.8368 10.2912 20.3964 27.2145 -12.4741 -6699 6 35.4384 36.5941 19.4416 12.9267 19.1414 22.694 -6700 4 35.4164 36.6623 20.432 -0.885856 -8.21646 -20.3497 -6701 4 36.1159 37.2681 19.2232 -9.51806 -6.29836 -4.59986 -6702 6 39.0948 17.8654 12.2958 16.402 12.2899 -6.89152 -6703 4 39.0474 18.8007 12.5965 -2.38328 -10.6878 -1.40665 -6704 4 38.4419 17.3626 12.7715 -16.1853 0.319976 14.0097 -6705 6 2.67108 27.1436 2.40101 -1.75759 -3.65761 -8.1759 -6706 4 1.9876 27.5644 1.84788 8.2175 -2.76418 4.2561 -6707 4 2.53155 27.392 3.3289 1.87867 -1.67129 -3.85288 -6708 6 12.3359 32.2055 21.5153 -21.7508 0.12991 31.168 -6709 4 12.6488 32.0797 22.4173 29.0853 13.2861 -13.6486 -6710 4 11.491 31.8094 21.7155 -17.148 -0.720271 -25.2422 -6711 6 32.8833 32.3716 8.45599 -19.6455 -21.472 -14.5807 -6712 4 33.4538 32.8256 9.05859 9.48117 21.6574 11.6239 -6713 4 31.9723 32.7028 8.50155 9.17651 3.82723 3.41156 -6714 6 12.6485 6.44458 31.9777 -6.29944 1.49663 15.4125 -6715 4 13.1578 6.35833 31.1835 12.9638 -3.65534 -14.9347 -6716 4 11.7474 6.25334 31.7296 -4.07419 -1.29291 -2.47195 -6717 6 41.3645 27.7433 14.0415 -6.01814 -18.8263 -25.007 -6718 4 41.8124 27.3175 13.2596 -11.5333 15.588 22.1217 -6719 4 40.3975 27.5756 13.9407 20.5065 3.01622 5.4742 -6720 6 6.60161 16.499 25.4489 9.93734 -1.87947 -15.8553 -6721 4 7.35848 15.8951 25.4583 3.3895 5.33583 -1.00098 -6722 4 6.02379 16.0419 24.8253 -6.53341 1.34025 8.2366 -6723 6 21.7786 39.2974 13.3607 -58.7317 27.2846 42.4257 -6724 4 22.3848 39.3902 12.6828 41.4687 -6.70168 -50.5194 -6725 4 21.6228 40.2371 13.624 5.27297 -27.3266 2.34771 -6726 6 34.8408 6.01319 6.94562 -18.4641 -1.51643 5.78804 -6727 4 33.8445 5.90926 6.91888 31.3517 2.57767 -4.40922 -6728 4 35.1545 6.28252 6.0657 -8.54142 -2.93715 0.97402 -6729 6 33.0232 30.4151 33.1713 -30.7469 -3.39927 -39.9685 -6730 4 32.1382 30.6983 32.7963 25.7009 -18.3352 9.36685 -6731 4 33.1108 30.988 33.8978 7.7837 23.494 30.6115 -6732 6 15.4491 32.4129 12.2013 37.3068 -21.1945 16.3611 -6733 4 16.3823 32.073 12.2446 -28.3662 8.39135 1.47263 -6734 4 15.4224 32.8258 11.3561 0.313824 15.5191 -23.5701 -6735 6 12.6648 26.6033 21.3782 33.3074 -46.6123 -64.9668 -6736 4 12.0344 25.8976 21.5501 -12.6652 14.4466 17.403 -6737 4 12.7392 27.3327 21.935 -15.9008 39.2731 46.5109 -6738 6 47.0171 36.3051 29.9756 -14.9097 -3.99946 59.7783 -6739 4 47.3887 37.0247 30.5306 -0.120183 -5.44251 -19.0377 -6740 4 46.4147 35.8463 30.6463 22.302 11.6315 -30.1098 -6741 6 0.299553 12.7005 23.3858 -50.0817 10.3486 20.6993 -6742 4 0.55843 11.8154 23.133 6.9712 -0.709946 -9.28769 -6743 4 54.2783 12.6185 23.429 39.7411 7.62342 -2.706 -6744 6 54.1651 18.9185 21.5773 -27.3575 7.2555 -32.8787 -6745 4 0.055729 18.801 21.8215 42.2187 -10.4087 33.76 -6746 4 54.2632 18.7361 20.6344 -21.3012 2.13243 0.141772 -6747 6 25.7162 24.2884 23.7449 23.2111 -33.139 -2.25213 -6748 4 25.1836 23.5617 23.2944 18.61 24.747 21.927 -6749 4 26.5708 23.8587 24.0884 -36.4232 14.4676 -16.0896 -6750 6 11.8952 29.0236 26.8796 9.31073 -5.31833 9.58593 -6751 4 12.582 29.6684 27.1204 -3.01706 -1.21814 -5.31042 -6752 4 12.0145 28.319 27.5465 -5.16863 11.8863 -12.5997 -6753 6 48.0052 35.8598 10.6996 -18.0426 -22.591 -32.4945 -6754 4 48.7896 35.6794 10.1443 -7.64403 10.0758 9.7343 -6755 4 48.2747 36.3464 11.4544 19.4818 11.8303 20.3364 -6756 6 47.6544 29.8545 36.9555 47.7155 -39.8456 -42.9298 -6757 4 48.1196 29.373 36.1789 -16.9409 17.9192 43.9777 -6758 4 46.9556 30.2951 36.4995 -17.6283 12.0501 3.0439 -6759 6 7.32865 12.3513 10.6225 -20.3459 13.1064 -14.334 -6760 4 7.20572 12.8267 9.76478 7.03806 -14.4953 16.449 -6761 4 6.49136 12.5857 11.0944 24.1086 -12.0498 -8.15528 -6762 6 52.9256 15.9641 4.89737 -18.3283 -2.7411 -11.4996 -6763 4 53.001 16.1105 3.94443 2.36662 -0.713792 8.85774 -6764 4 53.8018 16.0105 5.25645 21.1817 2.44507 8.14275 -6765 6 10.6731 16.9472 34.6118 -36.7423 -4.99845 -47.4494 -6766 4 11.0533 16.8484 35.4724 -5.12202 -12.2675 26.0308 -6767 4 9.83371 16.4151 34.3796 40.245 18.7583 25.5995 -6768 6 25.147 31.0596 36.0152 -5.60145 -19.7687 -32.0201 -6769 4 25.7935 31.7656 36.1171 1.22463 2.78419 -3.72446 -6770 4 25.3418 30.5949 35.1615 -4.38154 15.6016 24.1358 -6771 6 34.0913 21.8858 41.4775 -4.76405 18.1665 32.5634 -6772 4 33.6625 21.1007 41.1787 -2.29922 -28.5955 -6.85504 -6773 4 34.6054 22.1733 40.7506 14.2114 10.2598 -30.2937 -6774 6 15.7731 30.0818 1.26798 39.0641 -13.3599 -49.0464 -6775 4 15.0823 30.4241 1.791 -23.818 19.5269 30.6537 -6776 4 16.2108 30.862 0.84325 -15.3415 -19.24 18.755 -6777 6 29.5302 27.8609 16.6022 -41.3972 -29.0796 28.0786 -6778 4 29.3307 26.8764 16.753 17.6765 42.2449 -1.67193 -6779 4 28.8227 28.3009 17.156 20.6394 -5.21731 -15.3441 -6780 6 39.6438 9.77612 0.552706 9.07327 13.2864 29.0584 -6781 4 40.129 10.5839 0.897097 -15.1313 -20.9808 -12.8857 -6782 4 39.4906 9.23066 1.36029 2.34479 9.54176 -15.0004 -6783 6 1.51524 31.8825 16.4089 -15.0842 0.567558 32.708 -6784 4 2.11225 32.2249 15.7721 17.5465 17.6302 -23.3114 -6785 4 1.56386 30.9485 16.2687 -0.663138 -25.5376 -6.36093 -6786 6 8.73078 39.8635 25.0545 2.96185 -34.7465 -17.9129 -6787 4 8.00321 39.5602 25.6169 4.07363 9.59654 5.53067 -6788 4 8.89391 40.7829 25.2096 -1.06312 24.7623 5.36493 -6789 6 42.3301 10.2778 9.76455 0.0249942 22.0437 -8.66619 -6790 4 42.035 10.1947 10.6715 6.68889 -4.55788 7.04955 -6791 4 42.6957 11.1854 9.68656 -1.85544 -15.7885 0.75259 -6792 6 13.241 7.61416 1.95847 -11.6175 -6.73398 30.6404 -6793 4 13.9892 7.82191 2.54806 -1.36929 5.6022 -7.80568 -6794 4 12.5695 7.22502 2.56499 11.7798 7.16895 -16.7116 -6795 6 18.7434 40.0583 14.2212 10.8937 -7.32712 21.4541 -6796 4 19.2417 39.7541 15.0131 -1.99408 15.6159 -18.1773 -6797 4 17.935 39.549 14.2832 -4.44855 -3.57314 -3.37042 -6798 6 20.0977 14.0454 38.5561 35.4799 -67.417 -7.49733 -6799 4 20.2641 13.632 37.67 -9.31749 10.6865 24.2255 -6800 4 19.7827 14.877 38.3297 -23.7972 64.5272 -8.60678 -6801 6 22.6565 28.8842 34.0588 -5.52315 8.37947 20.7951 -6802 4 23.0585 28.228 33.4828 2.77778 -4.34029 0.307399 -6803 4 22.9395 28.703 34.9822 0.354749 -6.57221 -14.6515 -6804 6 22.6874 4.70198 5.2328 -25.042 -9.90055 15.5414 -6805 4 22.1274 3.9708 5.56882 12.1557 -0.0327816 -16.8284 -6806 4 22.5434 5.31639 5.94822 12.9551 16.3877 4.62095 -6807 6 23.6492 33.9942 38.3998 23.375 33.8394 -43.1733 -6808 4 22.8011 33.6715 38.57 -44.227 -25.7371 21.164 -6809 4 23.4749 34.4069 37.5183 19.103 -7.547 16.6445 -6810 6 48.374 21.3549 17.2744 -0.727013 41.2048 -23.9838 -6811 4 48.2041 22.3166 17.0448 3.0192 -25.1475 26.0409 -6812 4 48.3509 20.9743 16.3868 -2.31832 -8.94154 10.8829 -6813 6 11.5758 10.9938 8.63273 -18.0621 42.8191 15.9647 -6814 4 11.6313 10.2483 9.25156 -2.19238 1.01339 1.87179 -6815 4 11.0547 11.7764 9.03291 21.9333 -36.8133 -6.7089 -6816 6 40.0924 28.1686 33.4857 17.1635 -5.37387 30.2378 -6817 4 41.046 28.3881 33.5354 -13.2006 -3.32107 -11.2861 -6818 4 39.7443 28.4933 32.6629 4.51627 6.28126 -11.3213 -6819 6 47.3837 25.6703 5.29617 28.7657 21.9065 -4.48206 -6820 4 46.461 25.5322 5.12569 -20.8862 2.51482 -4.893 -6821 4 47.6179 26.6114 5.08959 -12.3293 -15.1007 -0.275896 -6822 6 21.6517 35.2222 23.996 27.7917 10.3485 -3.89698 -6823 4 21.6311 34.5383 24.6593 -10.5502 -12.8786 6.64496 -6824 4 22.5954 35.4881 23.9966 -15.7417 2.23004 -2.6139 -6825 6 8.24409 41.4919 8.41354 9.22969 12.4334 -12.8549 -6826 4 8.15 40.8674 7.67873 -1.07657 -2.81584 5.48771 -6827 4 7.83543 41.113 9.18983 -1.52095 -3.2343 5.88405 -6828 6 16.4798 31.1082 22.2131 -4.24513 -17.8742 -2.35359 -6829 4 17.0752 30.8161 21.5077 -7.18137 4.28218 -7.0656 -6830 4 17.0564 31.1902 22.9696 5.97679 -0.907857 10.4567 -6831 6 54.7122 0.459271 28.3177 -16.7834 -37.5181 -6.57119 -6832 4 0.641958 0.15455 28.3975 4.09167 16.1916 -1.73275 -6833 4 54.5379 1.34634 28.6236 20.797 14.6923 4.72985 -6834 6 48.4477 15.3762 4.17752 -7.35125 -30.0531 -4.44848 -6835 4 49.1738 15.1128 4.81019 -14.8803 0.337287 -24.8229 -6836 4 48.0902 14.5922 3.6288 23.2827 31.0113 24.8784 -6837 6 34.3541 7.00171 40.4295 26.6588 -46.9533 -23.8625 -6838 4 33.6168 6.99428 39.8319 -14.4938 10.2897 -3.98371 -6839 4 34.9839 6.35967 39.9588 -19.3291 28.4488 24.7248 -6840 6 41.3507 3.37676 17.0028 -19.6969 -26.4955 -6.96819 -6841 4 41.02 2.66518 17.5936 5.53648 12.9859 -1.78552 -6842 4 41.944 3.90566 17.5305 10.5068 9.85924 8.73726 -6843 6 48.4427 20.685 14.5419 46.8112 -36.6841 26.4704 -6844 4 48.0177 21.3487 14.0717 -32.7597 47.8552 -32.6818 -6845 4 49.3877 20.9188 14.5227 -9.08294 -4.43462 -1.64124 -6846 6 52.4922 28.1277 37.1182 6.87418 8.84651 -10.3419 -6847 4 53.4134 28.4024 37.0408 3.12987 -6.6922 4.15316 -6848 4 52.2752 27.8963 36.2007 -7.47166 7.06161 9.73328 -6849 6 53.8774 18.5638 18.79 -18.2161 -77.5341 7.0005 -6850 4 54.7018 18.1425 18.5274 3.76082 -0.315502 -3.76089 -6851 4 54.0435 19.4528 18.7445 16.4561 77.5259 -2.54699 -6852 6 41.0011 39.1407 28.7879 -31.3786 -4.09579 71.7092 -6853 4 41.3911 39.2094 27.9661 28.9736 8.71878 -68.6315 -6854 4 40.0521 39.3021 28.7019 -2.27612 -3.41331 -6.23213 -6855 6 38.2743 8.75074 24.2285 24.5029 -7.68366 -19.8132 -6856 4 39.1919 8.60362 23.8621 -28.3827 4.68959 18.7737 -6857 4 38.3545 9.42009 24.9092 0.456349 2.35846 11.2764 -6858 6 2.99111 29.1615 9.6319 43.2691 -54.6401 14.341 -6859 4 2.5338 28.6319 8.99687 -12.0219 1.86489 -18.3516 -6860 4 2.58318 29.9865 9.638 -27.8835 49.5023 8.75508 -6861 6 27.5756 29.2755 18.3378 -4.01048 -11.7045 41.1881 -6862 4 26.7643 29.1652 17.8389 -11.7278 -2.11582 -9.62984 -6863 4 27.2839 29.0037 19.2864 20.9622 13.2114 -52.0932 -6864 6 11.8501 21.1733 10.1172 4.58733 -51.566 26.4002 -6865 4 12.2099 22.0246 9.9906 13.4732 33.828 -10.0235 -6866 4 12.4495 20.7458 10.776 -15.5727 16.0367 -15.8372 -6867 6 16.9004 32.2989 0.299881 0.133752 -22.2186 -6.7835 -6868 4 17.7029 32.7095 0.626455 9.4749 11.3588 3.4417 -6869 4 16.2118 32.9605 0.285394 -3.66285 20.1796 -4.1714 -6870 6 1.30064 17.4766 22.5523 32.9941 -5.4384 -19.965 -6871 4 1.2446 16.5356 22.2294 -6.1018 21.6977 3.5382 -6872 4 2.22906 17.8023 22.3815 -23.7878 -13.737 8.2324 -6873 6 41.5474 6.85538 29.3077 15.2611 30.5857 3.861 -6874 4 41.7413 5.96016 29.5642 -1.91107 -14.5726 0.121693 -6875 4 42.0251 7.37916 29.9826 -12.8279 -1.76094 -5.06557 -6876 6 10.5087 10.782 13.8577 27.0965 -13.6956 13.3978 -6877 4 10.7007 11.2274 13.0253 -2.16043 3.73872 -7.98734 -6878 4 11.2742 10.169 14.0479 -24.5023 11.0776 -3.5626 -6879 6 39.8289 15.4978 40.8346 25.2099 1.13818 0.661387 -6880 4 40.0487 16.0673 40.0758 -9.90377 -2.84048 2.34508 -6881 4 40.6829 15.4254 41.3222 -18.4618 6.82556 -4.74882 -6882 6 26.5164 19.6052 40.5088 -9.33805 1.61856 -11.7217 -6883 4 27.41 19.9717 40.4897 0.274496 -7.70925 5.49567 -6884 4 26.4209 18.9712 41.2422 6.64723 7.57269 5.06511 -6885 6 54.036 8.18782 13.7715 27.5212 34.9045 -2.54262 -6886 4 54.5316 7.46918 14.1378 9.61628 -19.3806 0.327355 -6887 4 53.1925 7.88218 13.5309 -39.9219 -15.1658 -7.5943 -6888 6 15.6949 25.3434 10.6718 -31.7842 -7.37099 0.0612328 -6889 4 15.1805 25.3333 9.84403 14.6699 1.30202 -4.92807 -6890 4 14.9666 25.3615 11.3188 15.8696 -4.15214 -3.47235 -6891 6 18.5987 3.44175 21.9294 71.7321 -9.69418 15.9409 -6892 4 19.6071 3.44542 22.1959 -64.1569 1.8736 -14.3483 -6893 4 18.6296 3.58776 20.9721 -7.77871 5.49431 4.81248 -6894 6 50.8883 20.6265 18.5187 28.1172 41.6529 17.9746 -6895 4 50.1573 21.1733 18.1958 -9.23125 -9.06144 -4.34911 -6896 4 51.4834 21.2842 19.0045 -23.468 -29.5191 -15.1667 -6897 6 53.3673 20.9038 31.2869 -12.1652 -1.18869 -3.23134 -6898 4 53.2409 20.9073 32.2442 5.88471 -1.70994 -0.407299 -6899 4 52.4717 20.8062 30.9053 11.2743 1.61965 3.90294 -6900 6 52.8102 27.6189 28.9831 -34.4743 -7.30027 30.0453 -6901 4 52.2848 27.4362 29.7987 1.4862 0.901255 -27.4551 -6902 4 53.4947 28.1361 29.3473 35.4934 25.3811 1.80223 -6903 6 33.3112 15.6955 11.3264 12.7704 9.00306 37.7013 -6904 4 33.4999 16.1238 12.2198 -3.00415 -23.4283 -28.8796 -6905 4 32.4346 16.0003 11.1059 -7.33456 8.94646 -4.12361 -6906 6 20.3875 26.8057 27.4813 21.213 -4.31231 15.2493 -6907 4 19.6396 27.3594 27.2578 -2.8557 9.66202 -0.370116 -6908 4 20.9667 27.2946 28.1279 -24.4059 -13.8952 -19.2793 -6909 6 8.54399 2.06163 14.1713 4.36483 17.1543 -0.299448 -6910 4 8.13837 1.20516 14.196 -9.47708 -17.773 2.17407 -6911 4 8.01805 2.60085 14.7902 6.78451 -6.83093 -3.12033 -6912 6 40.1002 7.56575 40.6778 12.4019 9.60944 38.6013 -6913 4 39.712 8.14959 41.3779 4.03526 -4.70584 -30.6789 -6914 4 40.8329 7.16354 41.1893 -8.78874 -6.51591 -16.4763 -6915 6 6.89044 6.83556 10.7869 16.1514 15.8461 -3.23426 -6916 4 7.31622 7.70217 10.5979 -16.164 -15.6489 3.8938 -6917 4 7.04178 6.69918 11.735 -3.2221 -0.411834 -4.21297 -6918 6 31.2643 6.58983 20.136 22.5576 -57.6677 6.94967 -6919 4 30.6637 5.92034 20.5005 -2.47046 2.78164 8.35653 -6920 4 30.7152 7.30056 19.9711 -35.0351 52.1138 -11.6241 -6921 6 54.5411 21.0454 27.2925 4.1013 -43.0328 84.8338 -6922 4 0.071192 20.2129 27.5399 -15.6737 30.1382 -21.2093 -6923 4 54.6532 21.3072 26.4181 12.1035 8.54749 -60.3726 -6924 6 4.75213 23.1508 16.2245 -49.4139 4.34438 -28.0546 -6925 4 4.2471 24.0009 16.1592 20.3634 -17.2761 5.59937 -6926 4 5.4972 23.3136 16.7675 27.2932 5.42097 22.4316 -6927 6 25.5515 11.0241 14.8358 9.2665 0.546345 5.2197 -6928 4 26.0976 10.3608 15.3182 -9.73323 12.0118 -14.516 -6929 4 25.8683 11.8947 15.1133 0.0398252 -5.90721 -2.6003 -6930 6 41.1974 41.7784 29.942 -27.7855 -7.97533 -10.6302 -6931 4 40.9203 40.8727 29.6366 8.3922 29.767 6.72032 -6932 4 40.4023 0.465719 29.8931 18.9924 -15.525 2.17149 -6933 6 52.2793 15.2936 41.6313 19.4314 -9.06844 -20.2837 -6934 4 51.991 15.9601 0.331443 -10.9307 10.9541 10.4228 -6935 4 51.6032 14.6231 41.5544 -13.8311 -6.7739 0.824233 -6936 6 37.7418 21.7882 37.8505 9.73059 24.2058 3.49681 -6937 4 37.8176 20.8655 37.6583 6.26781 -24.8638 0.142384 -6938 4 38.1128 21.8753 38.7352 0.661952 0.248137 2.40564 -6939 6 23.8436 9.73697 27.5598 -17.3101 -56.824 -21.1542 -6940 4 23.6823 8.97924 26.8635 13.0753 42.6322 38.797 -6941 4 23.3674 9.48178 28.3892 6.27388 8.11738 -19.7561 -6942 6 43.0121 28.0431 32.8137 29.5034 -18.022 1.83467 -6943 4 42.9555 27.148 33.1715 -16.7807 6.42622 4.12236 -6944 4 43.9561 28.0675 32.5908 -15.6612 14.0802 -2.62256 -6945 6 34.1451 21.2362 11.9042 -10.4207 -39.0944 -3.26361 -6946 4 33.7785 20.3444 12.1585 8.75301 27.3815 0.918114 -6947 4 33.7383 21.3833 11.0382 -2.92284 10.3561 2.31655 -6948 6 10.5016 31.8267 10.0873 5.91889 6.7472 5.74276 -6949 4 10.9186 32.6594 10.3946 -11.2895 -14.4825 -9.55855 -6950 4 9.99233 32.0033 9.274 9.03923 7.50024 8.93884 -6951 6 35.8744 37.1309 22.1208 9.07655 -0.20125 -37.6945 -6952 4 36.7757 37.5102 21.9868 -16.2539 -8.14962 7.83623 -6953 4 35.5893 37.243 23.0078 -0.963312 7.56509 34.0991 -6954 6 27.293 4.59192 27.4599 -62.9251 -2.97268 8.43797 -6955 4 27.8573 4.63875 28.2367 1.75868 -0.322614 6.7695 -6956 4 26.3027 4.46726 27.7774 60.9698 2.85981 -12.9146 -6957 6 39.0165 22.2861 10.6525 -25.2911 9.99335 20.5692 -6958 4 39.5938 21.9801 9.97437 16.8498 -5.94336 -19.6369 -6959 4 38.1468 22.3658 10.2352 2.38909 -7.32087 0.337973 -6960 6 30.765 39.1813 10.9358 -26.8864 17.0789 0.421318 -6961 4 31.7273 39.1993 11.0368 0.254075 -10.0442 -6.8497 -6962 4 30.3957 38.288 10.8473 24.5485 -0.522695 0.476538 -6963 6 44.5972 26.9475 2.20695 17.6159 -27.9211 -0.145864 -6964 4 44.8477 26.0903 2.61727 -13.9349 20.2639 -7.87324 -6965 4 45.3006 27.0404 1.55025 0.322606 15.9 1.66232 -6966 6 23.7817 14.549 26.4845 -13.1218 37.1912 -28.6876 -6967 4 23.5085 15.1786 25.7375 18.3344 -26.327 26.4977 -6968 4 23.2314 13.7794 26.3439 -3.10125 -8.02717 6.138 -6969 6 38.3349 13.3785 39.6531 51.0719 11.8768 18.627 -6970 4 39.1134 13.8424 40.1004 -28.3003 -20.0613 -21.9332 -6971 4 37.637 14.0102 39.7945 -20.9869 -1.09015 1.55638 -6972 6 17.9076 17.2343 29.3998 2.5182 -11.8623 9.07057 -6973 4 17.7005 16.8028 28.5679 -0.208052 -3.06359 -6.42367 -6974 4 17.2973 17.9612 29.4206 -13.3644 14.2602 6.84169 -6975 6 17.427 29.8312 9.9167 5.70667 9.14636 11.5297 -6976 4 16.5259 29.8398 9.63655 -18.5043 -5.93208 -2.5299 -6977 4 17.9097 29.6705 9.11934 16.3543 -3.78316 -10.6623 -6978 6 35.6302 6.05705 19.6249 -12.632 -1.17761 -30.1407 -6979 4 35.1756 5.57436 18.904 4.12491 -0.359791 14.6292 -6980 4 35.7342 6.9119 19.1826 9.40393 1.91765 12.7562 -6981 6 18.674 22.2857 17.523 8.42296 3.39096 21.1197 -6982 4 17.7402 22.4481 17.6821 -9.17854 0.615652 -6.61815 -6983 4 18.8674 22.3747 16.5992 -7.41694 3.44878 -20.9034 -6984 6 20.0258 3.81405 32.2871 -5.45876 10.2161 0.982716 -6985 4 19.684 4.03807 31.424 -2.67861 3.00481 -7.64614 -6986 4 20.9375 3.54321 32.099 -1.59169 -5.33194 9.42598 -6987 6 5.47094 6.98417 8.10987 -1.95658 -27.204 5.03178 -6988 4 5.85072 7.84658 8.088 3.96324 28.039 -6.11929 -6989 4 5.94584 6.55919 8.82772 -3.50663 -6.33739 10.9422 -6990 6 44.182 20.5312 25.5979 43.1361 -13.705 -19.148 -6991 4 44.6875 21.1042 26.1493 -15.9255 27.6084 29.7698 -6992 4 44.9726 20.2272 25.1253 -26.0739 -14.4287 -20.9555 -6993 6 43.9621 36.9892 17.8709 27.7049 17.1418 -9.42399 -6994 4 44.6647 37.4643 17.3692 -13.724 -4.61297 12.4448 -6995 4 43.6121 36.3808 17.225 -14.1002 -14.0328 0.985329 -6996 6 34.6183 10.1148 16.2555 -4.96303 14.2933 -37.1542 -6997 4 34.4099 10.1014 15.264 7.63186 -7.52385 38.4141 -6998 4 34.6455 11.0716 16.4378 1.03434 -4.81203 3.48645 -6999 6 23.6535 3.43617 1.32551 9.32991 -27.0385 -60.023 -7000 4 23.5361 2.47498 1.09872 1.70789 26.2755 24.74 -7001 4 23.8607 3.79652 0.414552 -11.3127 6.44054 37.9529 -7002 6 33.4225 38.9606 5.09116 -45.0556 15.9463 14.7537 -7003 4 32.9187 38.171 4.91655 10.2233 -24.4058 -4.43744 -7004 4 32.6531 39.5198 5.39063 34.9247 3.3662 -8.43025 -7005 6 22.5542 32.508 35.8091 -1.62577 21.6885 -22.4452 -7006 4 23.4313 32.1432 35.8321 13.5304 -8.64793 9.08541 -7007 4 22.6972 33.4304 35.4917 -7.91418 -12.6316 15.6694 -7008 6 32.4209 37.2696 13.8263 22.6153 37.4816 -15.7005 -7009 4 31.6314 36.8608 13.5507 -35.0264 -17.3769 -13.0658 -7010 4 32.7321 36.7183 14.5153 12.3601 -27.6025 17.2047 -7011 6 52.6048 12.7515 39.5965 -13.8302 -6.28036 -1.32475 -7012 4 53.26 13.3571 39.2655 9.70847 9.80763 -6.22213 -7013 4 53.0114 12.2827 40.3245 7.10516 -3.61819 3.538 -7014 6 28.8284 14.5654 1.23244 38.3097 18.383 -14.9432 -7015 4 28.2834 13.8143 1.34735 -23.3809 -22.0338 3.15251 -7016 4 28.3672 15.33 1.56727 -9.74512 0.414323 3.22557 -7017 6 1.45359 32.4205 23.3989 -1.05001 -40.1011 -18.1189 -7018 4 1.47013 31.5606 22.9188 -1.41837 10.7967 19.8874 -7019 4 1.97354 32.9442 22.8182 11.5552 29.203 -12.5869 -7020 6 54.3296 23.3325 28.9716 1.50467 4.34178 0.834044 -7021 4 54.2574 22.8567 29.7964 -0.193368 0.82753 11.1745 -7022 4 54.4723 22.6371 28.331 0.325397 -5.40149 -8.07104 -7023 6 14.3127 12.1509 35.6633 -33.5663 -10.8168 -13.6472 -7024 4 14.2878 12.7047 36.4184 6.74358 21.3133 20.6565 -7025 4 15.1756 11.8015 35.6107 35.8459 -8.25269 -4.05635 -7026 6 18.9986 6.53226 41.2771 -21.1361 -24.8418 -24.3627 -7027 4 18.366 5.78703 41.1105 9.63211 18.6573 18.8829 -7028 4 19.3119 6.48514 0.272589 3.11598 2.01554 11.5533 -7029 6 5.32991 17.8836 20.3428 -30.4167 16.0599 6.69424 -7030 4 4.7967 18.411 19.709 2.93149 -9.05217 4.33299 -7031 4 4.77097 17.8526 21.1546 15.0176 4.61027 -13.5236 -7032 6 24.7236 34.9657 30.1688 -3.59195 -26.0802 -14.261 -7033 4 24.7803 35.9013 30.0428 5.00342 21.1487 3.94382 -7034 4 24.6904 34.5809 29.2706 1.13339 13.2018 12.9935 -7035 6 31.868 4.6188 18.1813 26.0749 -11.7783 -2.21043 -7036 4 31.7807 5.26575 18.8694 -2.85928 14.415 8.06415 -7037 4 31.0011 4.54965 17.8036 -17.7428 -0.954819 -5.29079 -7038 6 8.70915 17.4782 5.92977 -5.10088 36.478 0.166614 -7039 4 7.99285 18.1665 5.8727 10.0003 -20.7449 -0.10219 -7040 4 9.53277 18.014 5.87919 -8.17468 -12.6369 7.06335 -7041 6 29.8448 10.9674 14.467 -9.24737 10.8237 6.24964 -7042 4 29.3518 11.4625 13.8111 -3.5417 -3.22768 -11.9456 -7043 4 29.8741 11.602 15.1948 7.6561 -6.41884 12.5924 -7044 6 48.7193 10.2987 32.5837 48.7914 -16.5053 -5.27468 -7045 4 48.664 9.84191 33.449 -1.5926 15.0761 -9.20872 -7046 4 49.6917 10.1556 32.2801 -49.2626 10.4163 8.33251 -7047 6 8.33128 15.6672 37.865 4.36755 4.12409 -33.9682 -7048 4 8.08142 16.0688 38.661 -6.22033 14.9054 48.1983 -7049 4 7.78443 16.1766 37.2488 7.82296 -4.92397 -7.06368 -7050 6 50.3849 3.07587 17.3306 53.0616 0.797084 -5.54454 -7051 4 49.9901 2.96071 16.4818 -23.7547 4.5323 -14.3202 -7052 4 49.831 3.21284 18.0832 -29.2444 4.71684 15.357 -7053 6 14.687 38.3962 10.9034 11.8452 2.26847 -28.7684 -7054 4 14.4993 38.5723 11.8231 -13.1425 0.700252 11.382 -7055 4 14.2628 37.5785 10.602 -2.45756 1.24341 13.1034 -7056 6 34.1174 6.37976 10.8168 12.9161 5.50138 13.5595 -7057 4 34.1292 7.23477 10.3416 2.23773 -14.4836 1.59416 -7058 4 34.9287 6.34152 11.3848 -14.7297 9.70771 -12.8953 -7059 6 7.1619 37.5492 17.6341 50.2032 -5.81562 0.15107 -7060 4 8.17599 37.5098 17.465 -47.7372 -0.307972 7.49553 -7061 4 7.05745 37.0565 18.4805 -8.53445 9.44148 -12.9936 -7062 6 51.515 11.3168 16.7982 -26.0757 5.86397 -27.0874 -7063 4 52.235 10.8459 17.1551 30.0977 -19.3818 20.7126 -7064 4 51.5008 11.0547 15.8562 -2.22905 10.0255 8.80825 -7065 6 15.6633 8.64974 3.19872 2.04011 -21.0584 -36.8111 -7066 4 15.359 9.2987 3.81038 -7.3063 19.0886 25.5551 -7067 4 16.1924 8.00887 3.67257 5.32849 -2.14206 7.59436 -7068 6 5.43671 21.4488 11.9213 -35.1135 30.2715 2.68526 -7069 4 5.1197 22.3031 11.5306 26.1226 -15.3225 -1.30607 -7070 4 4.71321 21.2794 12.5494 12.8867 -7.97314 3.40019 -7071 6 50.1888 24.041 37.9733 -16.5158 11.6838 -8.72192 -7072 4 49.5513 24.2503 37.2525 13.6843 -9.6942 16.9361 -7073 4 50.7608 23.3204 37.7156 0.52347 -2.66969 -5.08066 -7074 6 39.7366 11.2383 31.6978 23.7892 31.0409 -10.9794 -7075 4 40.3477 11.919 31.322 -8.85632 -23.7146 9.45819 -7076 4 38.8907 11.643 31.516 -11.7678 -2.00245 1.00495 -7077 6 26.6862 10.831 20.5846 -4.64528 13.8134 22.6501 -7078 4 26.37 11.3609 21.3584 5.46785 -6.26709 -23.7021 -7079 4 26.5097 9.94471 20.9062 3.28762 -9.42115 -6.7075 -7080 6 12.5617 17.5693 18.1619 57.3415 -16.6047 -35.4946 -7081 4 12.3732 16.6356 17.927 -10.1847 12.7431 11.2408 -7082 4 11.9536 17.9401 18.7496 -47.3477 6.23269 31.2745 -7083 6 47.7779 31.603 17.3345 -16.0229 -2.6295 -18.0517 -7084 4 48.4774 31.3981 17.9449 0.342859 -12.7175 10.4199 -7085 4 47.3751 30.7658 17.0144 6.51745 15.1025 2.87388 -7086 6 1.06661 3.38166 18.5387 0.482315 1.39351 -20.5486 -7087 4 1.47214 3.81044 19.3024 -7.19452 2.23946 8.83247 -7088 4 0.121217 3.21323 18.6865 2.92702 6.89788 10.7589 -7089 6 26.5916 20.3882 15.3141 4.05487 -19.1164 -7.10575 -7090 4 27.0276 19.5492 15.0037 -7.93965 16.9744 10.3813 -7091 4 25.6772 20.1067 15.4922 9.40368 -0.641397 -3.80974 -7092 6 42.0092 3.03717 36.7607 9.58516 7.42569 -27.539 -7093 4 41.472 2.27114 36.5289 -4.68032 -10.5632 12.6255 -7094 4 41.9749 3.27199 37.6769 -10.2045 -8.66607 25.0137 -7095 6 39.3197 22.4482 33.2161 17.1359 -6.1719 -1.11969 -7096 4 39.6777 22.5385 34.1471 -14.6651 4.73191 -34.7467 -7097 4 39.2891 23.3308 32.7977 1.66572 -7.01471 12.3298 -7098 6 18.4983 34.959 11.9233 -52.4092 11.8234 -6.15541 -7099 4 19.3311 34.9297 12.2931 62.358 -5.27325 28.8625 -7100 4 17.9525 35.2018 12.6795 -15.7268 -2.39727 1.11957 -7101 6 22.849 14.1156 0.206953 9.43339 -22.8796 20.8561 -7102 4 23.1273 14.7687 41.4941 9.338 18.1693 -9.76493 -7103 4 23.4344 14.2183 0.991573 -8.36464 7.13735 -11.7533 -7104 6 31.0127 16.6435 33.7717 -75.3989 -12.3916 10.6429 -7105 4 30.4261 16.8588 33.0132 20.7291 0.745933 12.1228 -7106 4 31.8948 16.7604 33.5238 39.9201 13.7608 -15.1754 -7107 6 28.4056 35.5121 5.54765 -4.91817 12.0412 -0.933493 -7108 4 29.0647 34.8486 5.74161 15.0982 -5.96625 -1.02933 -7109 4 28.8561 36.3656 5.44297 -1.6946 -6.58589 1.12865 -7110 6 2.06022 31.4415 10.6404 20.6415 1.38777 10.2498 -7111 4 2.4899 32.1989 10.2195 -2.44284 -2.19106 -3.22737 -7112 4 1.13111 31.6267 10.6164 -17.6565 -0.143118 -7.1498 -7113 6 5.95467 9.75858 21.3545 2.17354 8.87983 -50.8842 -7114 4 6.2643 10.5435 20.7894 -11.3634 -34.5597 22.4005 -7115 4 5.48441 9.14719 20.7121 9.8282 23.6666 23.1144 -7116 6 24.7866 26.6177 2.6661 -24.4024 -28.5469 2.9707 -7117 4 23.9476 26.6963 2.18158 9.10826 11.4817 -7.6186 -7118 4 24.6214 25.7954 3.1805 15.5163 19.2379 2.11057 -7119 6 45.7515 4.24664 18.6084 -0.948574 6.19926 2.59566 -7120 4 46.4738 4.91595 18.5123 -9.05862 -19.7882 -0.326833 -7121 4 46.0843 3.34349 18.421 4.31178 15.089 3.21664 -7122 6 4.45878 0.783326 15.9106 20.8465 2.39674 -2.22601 -7123 4 4.33336 41.7534 15.8294 -11.1347 -14.3847 -2.31303 -7124 4 5.37758 0.813141 16.2285 -10.0444 13.1447 -0.149196 -7125 6 2.44065 19.4988 25.3899 -18.2163 -19.9205 28.2208 -7126 4 1.89428 18.9873 26.0273 4.60516 17.0002 -8.33323 -7127 4 2.55045 18.8717 24.6878 9.48029 -1.77855 -17.0048 -7128 6 40.6027 8.48954 5.10826 -27.6355 -21.4881 -13.6167 -7129 4 40.6592 9.31425 5.57088 10.9479 16.5697 14.8472 -7130 4 41.3781 7.96424 5.30637 14.4251 2.68711 -2.52113 -7131 6 49.3092 22.3481 41.5186 -9.93734 74.0457 16.0776 -7132 4 48.4971 22.7919 41.1786 21.3857 -10.289 -0.267672 -7133 4 49.2285 21.4633 41.2985 -4.59952 -62.95 -16.8011 -7134 6 0.364483 40.9333 20.5966 -24.8933 -11.8265 -30.66 -7135 4 0.190818 39.9667 20.5681 4.35782 8.08342 1.06674 -7136 4 54.6936 41.3396 19.9676 13.1862 -7.22974 19.6204 -7137 6 34.8864 15.3279 38.0452 -17.1782 37.3505 -55.2903 -7138 4 34.2682 16.0872 37.9321 5.94042 -16.3876 6.60377 -7139 4 35.3697 15.4116 37.1797 -1.56134 -6.74346 24.1748 -7140 6 7.76223 25.9987 29.8652 25.7268 -8.51605 -4.95409 -7141 4 8.61839 26.4638 29.9588 -13.1921 -1.71741 1.7916 -7142 4 8.05672 25.0651 29.9772 -19.4202 16.3818 3.54783 -7143 6 40.7182 22.7954 20.4441 37.8127 13.8011 -33.8007 -7144 4 41.3586 23.4588 20.0133 -28.9149 -26.2189 23.8294 -7145 4 40.2017 23.2969 21.0583 -10.7099 15.3396 13.8501 -7146 6 37.6932 25.6399 36.0638 4.62997 10.0285 35.1853 -7147 4 38.3287 24.9236 36.1183 -2.20273 -4.01008 -9.65359 -7148 4 37.2914 25.6394 35.2107 -7.09628 -5.12362 -31.4654 -7149 6 5.46101 24.0014 10.2586 17.9799 16.5872 6.22131 -7150 4 6.04134 23.844 9.49543 -11.5162 -2.35388 5.85767 -7151 4 5.90746 24.7967 10.672 -23.415 -30.7572 -16.8601 -7152 6 48.4104 21.0451 38.1819 10.5351 27.9197 -28.7006 -7153 4 48.793 20.7803 39.017 13.2175 -6.38321 0.209366 -7154 4 49.1228 21.3802 37.5459 -28.8109 -18.4864 30.6779 -7155 6 15.2906 25.011 3.54101 2.70625 6.69817 -9.95824 -7156 4 15.4569 24.0555 3.50682 -9.52162 -0.514188 6.9158 -7157 4 14.6826 25.2483 4.2581 -1.83637 -10.9582 1.3864 -7158 6 46.3949 40.2718 20.0841 3.05266 -42.5213 0.389481 -7159 4 46.7282 39.319 20.1688 -17.5494 37.8624 -2.40649 -7160 4 47.138 40.8016 20.3323 14.2597 18.5668 -0.122304 -7161 6 34.6662 36.4732 0.324161 -52.0076 35.1593 -1.38074 -7162 4 34.82 35.9689 1.09464 17.4812 -18.6855 30.1307 -7163 4 33.7817 36.8781 0.601954 33.7085 -7.09846 -24.72 -7164 6 52.5968 8.00424 30.4116 -30.791 -5.83914 -1.44892 -7165 4 52.0396 8.66036 30.8559 12.8564 7.40177 -0.477247 -7166 4 51.9287 7.58179 29.8369 22.2614 -6.63703 0.63559 -7167 6 32.0772 3.86049 29.4688 -16.0025 -7.01815 -35.05 -7168 4 31.5382 3.03776 29.5615 20.8838 14.671 -1.22835 -7169 4 32.0904 4.03293 28.4798 -1.86833 -11.5506 40.3284 -7170 6 20.363 17.8245 28.646 3.47804 13.7512 -7.92665 -7171 4 19.5516 17.4966 29.0653 6.53113 9.74715 -6.36853 -7172 4 20.0825 18.3002 27.8308 0.555567 -8.90179 15.8758 -7173 6 30.4041 41.1634 41.0132 -16.7253 12.0993 -9.83452 -7174 4 30.5197 40.835 40.1072 4.71307 -5.7925 7.34595 -7175 4 31.1703 40.9637 41.5368 18.7313 -7.07732 1.06037 -7176 6 35.4542 32.8539 27.9215 21.6406 26.5455 -21.3275 -7177 4 35.1435 33.2362 28.7432 -6.21594 5.85967 7.97646 -7178 4 35.8745 33.6007 27.3754 -13.2283 -32.0923 16.9769 -7179 6 14.39 6.67952 12.731 -12.5058 36.491 0.424373 -7180 4 15.2321 6.28981 12.9462 8.74388 -6.1299 -2.75421 -7181 4 14.5067 7.66796 12.7988 -3.69921 -34.1177 -6.56265 -7182 6 41.8739 41.5433 20.319 24.4238 12.2951 6.29746 -7183 4 42.7192 41.2715 19.9184 -11.0628 6.38436 -6.30872 -7184 4 41.3184 40.7767 20.2955 -10.4459 -12.1473 -5.48062 -7185 6 46.3985 22.5739 8.8638 6.84921 19.3184 1.79378 -7186 4 45.8729 21.8991 8.42669 -3.07803 -12.5032 3.12866 -7187 4 47.1271 22.1566 9.33065 -8.50589 -8.34396 1.5145 -7188 6 17.4023 20.6526 13.9004 10.6995 28.5611 -11.4854 -7189 4 17.6978 21.6036 13.9579 -8.84666 -31.3302 7.07381 -7190 4 17.3123 20.5004 12.9448 0.490636 -3.23538 4.08121 -7191 6 8.20126 9.48382 13.3485 -42.4293 41.8522 17.2798 -7192 4 7.44487 10.0964 13.6076 19.5538 -29.8853 -13.4391 -7193 4 8.9576 10.0119 13.6277 13.7224 -9.45646 -1.54211 -7194 6 7.58554 14.8008 29.5824 -2.61798 9.90858 -2.64866 -7195 4 7.05733 14.3538 30.2458 -0.514214 1.68252 7.63674 -7196 4 7.01989 15.5029 29.2149 4.91731 -6.06465 -0.976267 -7197 6 29.5668 39.2268 22.6285 -3.66094 -2.39634 13.3419 -7198 4 29.8353 38.7557 23.4169 -4.20308 -7.76017 12.2752 -7199 4 30.3745 39.2765 22.1369 12.5997 4.36069 -18.8462 -7200 6 19.725 28.7952 8.44488 15.8543 2.58223 -4.45186 -7201 4 19.5131 27.8757 8.63421 -2.81313 1.38303 -4.16069 -7202 4 20.6983 28.808 8.54393 -13.7447 6.84799 3.59225 -7203 6 20.0995 21.6275 25.9249 -17.5249 50.4223 5.09745 -7204 4 20.7082 22.0204 26.5908 -8.84326 -18.264 -10.6066 -7205 4 19.3931 22.3347 25.9239 13.215 -30.9895 -3.48111 -7206 6 12.7711 16.1006 22.7986 17.0661 -2.75106 -3.7002 -7207 4 12.1316 16.7784 22.5952 -11.3059 6.43976 -4.8982 -7208 4 12.4647 15.3033 22.3372 -2.13756 9.04884 6.71194 -7209 6 7.09175 27.2069 17.991 -23.617 26.2366 -1.29155 -7210 4 7.8076 26.6007 17.9383 20.2011 -26.8554 -5.74897 -7211 4 7.19403 27.792 17.2318 3.33647 -0.0238245 -0.788587 -7212 6 32.3975 8.68618 34.8629 3.54321 22.8272 16.3539 -7213 4 32.7738 9.06402 35.707 -18.9002 -9.48773 -27.5474 -7214 4 31.4989 9.0701 34.6771 23.7457 -9.58556 9.46102 -7215 6 50.3515 28.2186 17.5351 -6.87553 0.519429 12.9107 -7216 4 50.2481 27.3572 17.999 6.5408 9.8464 -12.2276 -7217 4 51.0722 28.1417 16.8919 -2.26653 -7.3618 -1.59066 -7218 6 15.6741 32.1546 25.7968 -26.4348 -11.0143 -14.9159 -7219 4 16.4004 32.6083 26.1805 24.7846 13.6092 10.6573 -7220 4 15.1411 32.8481 25.3674 4.92309 -4.07512 11.5217 -7221 6 41.2877 22.001 29.6411 43.1174 -21.5596 15.2505 -7222 4 40.6305 22.5901 29.3541 -33.8214 23.827 -16.0773 -7223 4 40.8662 21.2212 29.998 -7.36398 -2.60921 4.02408 -7224 6 24.5416 12.7608 8.88206 5.17198 -11.9982 -20.3907 -7225 4 24.1774 13.5122 9.35398 1.69504 4.6425 -2.53241 -7226 4 24.2888 12.8675 7.94212 1.28664 -3.68024 15.0016 -7227 6 47.3025 20.1085 10.3977 1.21439 24.4816 37.2747 -7228 4 48.204 20.4596 10.4656 -0.7364 -8.12719 -10.3932 -7229 4 47.15 19.5905 9.61989 6.68365 -16.152 -23.0167 -7230 6 17.6916 14.2112 29.9613 0.736848 4.98565 -22.9932 -7231 4 16.8377 14.622 30.0672 -16.7241 9.37988 10.4211 -7232 4 18.1183 14.7557 29.2835 1.70081 -6.05446 6.16757 -7233 6 21.3481 34.5805 28.5342 -9.54463 9.82799 -20.865 -7234 4 21.5933 35.4178 28.0943 -1.05427 -4.62886 14.5387 -7235 4 21.7361 34.566 29.3968 13.4346 0.0141216 16.9261 -7236 6 35.1024 4.03924 4.01172 -45.5158 42.5484 12.3245 -7237 4 34.1858 3.89939 4.38295 32.1954 -12.7538 -7.33111 -7238 4 35.1016 5.02916 3.89259 9.91862 -26.8751 2.91657 -7239 6 29.9059 8.58368 22.6013 -13.5917 -22.6535 -48.6732 -7240 4 29.4773 8.30259 21.7189 15.3855 19.7125 42.6195 -7241 4 30.4378 7.8025 22.8052 -0.87874 9.41284 8.39762 -7242 6 9.78314 32.9658 15.9197 34.9354 -36.2496 39.6827 -7243 4 9.8463 32.0623 16.3137 -14.5131 14.3099 -26.4053 -7244 4 10.4229 33.3707 16.5321 -2.5459 17.7355 -14.0184 -7245 6 24.9212 14.2335 32.582 19.5351 -17.8621 25.1352 -7246 4 25.485 14.4356 33.3711 -14.9506 -0.509299 -20.0473 -7247 4 24.5508 15.0526 32.2925 -5.32053 16.7872 -6.18619 -7248 6 49.6539 21.965 26.2345 44.0267 25.2751 -8.97422 -7249 4 50.4399 21.435 26.5572 -22.3889 20.3635 -4.11669 -7250 4 50.0214 22.8598 25.9362 -18.5294 -37.2714 15.3372 -7251 6 39.2165 29.6282 28.7804 -1.72389 1.82743 -9.11301 -7252 4 39.3036 29.0201 29.5259 1.24025 -1.09654 1.55877 -7253 4 39.538 29.1266 28.0158 0.286751 -1.49672 5.82908 -7254 6 50.6899 34.7862 39.7499 25.3157 10.1005 12.0928 -7255 4 51.6472 34.6743 39.5192 -19.7186 -4.86584 -0.193213 -7256 4 50.1651 34.2508 39.1591 2.72681 -14.2758 -14.8682 -7257 6 29.2004 20.8742 19.5261 27.9811 -3.68804 20.7377 -7258 4 30.1466 21.1247 19.5553 -9.39276 -2.96688 2.79863 -7259 4 28.9246 21.1497 18.6738 -22.5466 15.5983 -24.0329 -7260 6 45.8438 1.42491 21.3861 -37.1737 6.40486 -10.0566 -7261 4 44.9885 1.11968 21.7285 6.97513 -0.0444158 -7.72874 -7262 4 46.4438 0.92117 21.8904 34.782 -15.8409 16.3481 -7263 6 26.1011 5.84859 12.9885 -16.9285 4.46913 -7.38549 -7264 4 26.5547 5.08441 12.6375 7.71787 -14.9735 6.0022 -7265 4 25.1614 5.66972 12.8036 4.71997 0.43883 -1.19571 -7266 6 9.00669 19.0403 23.7238 12.8928 30.373 -14.6892 -7267 4 8.06593 18.9071 23.7945 -12.9763 -5.98489 5.20443 -7268 4 9.0473 19.9093 23.2431 5.0983 -22.172 6.64837 -7269 6 47.6961 14.1782 40.0269 19.0377 9.97795 -11.4729 -7270 4 48.5222 14.3512 39.5239 -16.7083 -4.37767 10.6105 -7271 4 47.3795 15.0553 40.2888 -5.04524 -6.44815 -3.81417 -7272 6 47.9985 19.7874 0.500962 -66.9165 -27.0064 -39.4066 -7273 4 48.5513 19.9496 1.22397 26.1904 -2.55385 45.3318 -7274 4 47.2789 19.103 0.704655 34.6798 29.0788 0.973802 -7275 6 27.1606 39.6013 31.4318 -10.4761 -55.491 -38.6851 -7276 4 26.8926 40.2811 32.0159 -13.7359 20.3686 20.1783 -7277 4 26.3709 38.9998 31.2101 25.3937 25.349 18.055 -7278 6 20.7209 15.2822 27.3078 -0.805435 -7.71632 -8.78017 -7279 4 19.7876 15.3781 27.0487 8.25469 13.9731 2.34115 -7280 4 21.2532 16.0335 26.9925 -16.2498 2.55153 -4.46604 -7281 6 53.2722 3.12643 19.6849 41.3384 49.6686 7.26214 -7282 4 52.533 3.74254 19.7043 -8.02663 -2.92583 -3.0848 -7283 4 53.0086 2.23956 19.6703 -22.4403 -46.3419 -2.11618 -7284 6 40.7531 33.3786 24.0219 13.5521 -1.60379 23.9632 -7285 4 41.5067 33.1664 24.6167 -8.75803 3.71621 -14.936 -7286 4 40.1104 32.6626 24.1628 3.50492 2.6284 -2.95087 -7287 6 50.2066 37.8896 21.3771 44.4561 61.7722 -19.2089 -7288 4 50.9779 37.3435 21.496 14.3962 -14.5259 7.12428 -7289 4 49.4598 37.4098 21.5582 -59.0635 -51.549 13.7135 -7290 6 41.3233 2.3412 21.9924 -16.3503 12.7858 19.6024 -7291 4 41.3426 2.52207 21.0679 5.97541 2.4567 -21.4637 -7292 4 40.4663 2.75609 22.2585 17.532 -18.0725 0.252127 -7293 6 3.68867 21.2779 14.3383 -14.5707 42.5 -35.9941 -7294 4 4.12477 21.855 14.9587 9.56216 12.6885 8.47194 -7295 4 3.77328 20.4352 14.6935 9.76412 -50.205 23.6517 -7296 6 34.2782 11.1533 36.6146 -6.03132 -23.9347 13.7336 -7297 4 33.9924 10.5436 37.3334 13.9996 -4.78487 -21.5854 -7298 4 34.1172 11.978 37.0322 -7.62349 27.2634 9.28858 -7299 6 24.0533 21.9225 23.4615 4.73517 -5.47775 13.1649 -7300 4 23.9978 21.53 22.5886 6.00444 -6.53009 -8.74438 -7301 4 24.605 21.2935 23.9896 -10.4931 14.2472 -9.63662 -7302 6 18.8931 0.346665 4.41951 -1.70081 19.9518 7.76538 -7303 4 18.8368 41.3461 4.13842 4.04101 -8.25805 2.22226 -7304 4 19.3845 0.416823 5.25819 -4.2619 -8.11151 -12.0763 -7305 6 1.61167 7.82777 17.7295 14.4633 -7.55708 2.21629 -7306 4 1.68315 6.88308 17.5181 0.421421 7.02752 -3.81945 -7307 4 0.776664 7.94842 18.1735 -9.56642 1.01884 2.20602 -7308 6 9.88587 31.542 26.4865 27.4574 -58.0414 -32.6279 -7309 4 9.74723 30.8294 25.7579 9.18818 32.443 34.13 -7310 4 9.16596 32.1271 26.4328 -35.6644 31.0992 -1.66616 -7311 6 46.989 33.006 20.3636 -11.9681 -37.8677 44.1235 -7312 4 47.0707 32.5253 21.2626 7.56487 31.1056 -35.1941 -7313 4 46.435 32.3629 19.8924 4.61548 9.19147 -10.8851 -7314 6 49.5457 29.2916 21.3977 -38.7846 4.15079 -24.0209 -7315 4 50.3477 28.8236 21.2219 24.323 -7.55681 13.7085 -7316 4 49.5468 29.8542 22.1736 14.9668 -0.936193 10.2574 -7317 6 13.5153 31.8979 19.1528 13.8675 8.3184 29.6787 -7318 4 12.8458 31.9825 19.8587 16.0999 2.21739 -7.32054 -7319 4 14.3406 32.2634 19.5906 -25.0701 -6.26478 -24.6616 -7320 6 46.633 34.1066 16.9257 -0.036059 -36.1463 20.7227 -7321 4 46.8492 33.9929 15.9997 3.99258 8.43366 -10.882 -7322 4 46.9059 33.2223 17.3084 -4.9703 29.3867 -9.59361 -7323 6 19.7609 39.5392 2.42166 -7.20248 -0.896063 -14.0911 -7324 4 20.5606 40.0527 2.5788 -3.5749 4.99115 -1.28658 -7325 4 19.2738 40.0463 1.72337 11.6568 -15.7424 21.4794 -7326 6 16.5329 9.39795 28.3065 -12.6095 -8.72502 6.68605 -7327 4 16.4075 10.3536 28.3648 10.1088 3.80195 -3.74389 -7328 4 17.4502 9.20269 28.1082 11.2813 2.72217 -1.81406 -7329 6 3.0433 33.3643 8.96425 -4.92886 23.6682 -21.9772 -7330 4 2.41869 34.0757 8.74286 -2.57616 0.180013 17.6579 -7331 4 3.16376 33.0029 8.08154 7.55925 -16.3918 2.91827 -7332 6 49.6751 28.308 0.201579 -29.5359 7.30765 2.58258 -7333 4 50.5733 28.3754 41.8671 34.4717 0.327786 -9.88202 -7334 4 49.5726 27.4715 0.657175 -2.26504 -2.01296 8.34302 -7335 6 1.41619 6.84354 30.4994 -10.3235 0.0954103 3.42179 -7336 4 1.63397 7.74222 30.8225 4.19995 -13.4757 3.05915 -7337 4 0.761793 6.45905 31.124 14.5617 20.0187 -8.0296 -7338 6 19.7679 9.42131 33.717 -3.22882 -6.25654 -44.8315 -7339 4 19.9145 8.46604 33.7746 1.8774 1.59257 2.48781 -7340 4 19.5751 9.55831 32.7323 1.24521 6.76178 40.819 -7341 6 26.1724 11.919 3.61074 17.7641 10.7445 -19.8393 -7342 4 25.5356 12.1934 4.24073 -14.9718 14.8208 22.8097 -7343 4 26.0423 10.983 3.54915 1.55706 -20.7566 2.99847 -7344 6 33.2542 2.1444 18.2116 -1.15587 48.9982 3.93816 -7345 4 32.886 2.96086 18.6548 6.67205 -21.4839 -22.8104 -7346 4 32.6761 1.46025 18.493 -13.9253 -19.4899 6.26155 -7347 6 1.55797 29.1194 15.6221 -22.3111 36.2637 61.7506 -7348 4 0.853719 28.5449 15.936 -7.71843 6.28063 0.384394 -7349 4 1.90648 28.6788 14.9107 30.7784 -39.3832 -62.5327 -7350 6 41.7311 4.10421 39.5944 -40.7328 36.7616 -42.7174 -7351 4 41.3817 4.81242 38.923 27.6667 -38.3892 36.6931 -7352 4 40.9025 3.64602 39.8145 11.2401 -8.56921 5.26404 -7353 6 28.6823 41.7982 21.1955 47.2047 1.42594 -8.59686 -7354 4 29.177 0.720645 21.3267 -21.6507 -0.473723 0.486784 -7355 4 29.4617 41.2314 21.0003 -26.4876 -3.65191 3.02858 -7356 6 11.643 12.3982 35.4482 -35.2927 22.3423 -20.2863 -7357 4 11.5968 12.2307 36.3713 6.75035 -5.55932 30.2124 -7358 4 12.5522 12.401 35.2267 32.0712 -2.0845 -6.40416 -7359 6 9.80556 12.056 0.297197 42.0735 31.0338 -28.3715 -7360 4 10.6577 12.4693 0.65483 -33.0881 -22.384 -10.4034 -7361 4 9.20254 11.76 0.941289 -12.1624 -10.8407 36.4861 -7362 6 48.1632 12.393 9.2137 2.43833 7.21341 -5.5951 -7363 4 48.4522 11.811 8.50685 -9.57081 -7.25037 -8.94466 -7364 4 48.8896 12.3474 9.83523 7.41749 2.43397 12.8852 -7365 6 20.1331 24.378 18.9556 11.9182 2.36756 -38.9603 -7366 4 19.4372 23.8368 18.5171 17.2732 8.77886 9.60074 -7367 4 20.7988 24.6336 18.2364 -23.7637 -10.2166 26.3276 -7368 6 16.5494 31.2838 16.4573 -15.9423 3.69088 33.2062 -7369 4 16.5519 32.1922 16.7594 11.1434 16.9832 -11.781 -7370 4 16.1476 30.8867 17.2522 1.55385 -15.8871 -15.2552 -7371 6 1.78983 14.6435 36.2904 4.99553 5.58283 2.2492 -7372 4 1.04893 14.2282 35.8708 -13.8588 -3.35469 -16.6141 -7373 4 1.66905 14.392 37.2023 2.39459 2.07051 19.2387 -7374 6 4.37166 29.2153 29.5914 5.79168 20.1405 -19.3585 -7375 4 4.91557 28.7254 30.2154 7.17051 0.117226 5.39869 -7376 4 4.91513 29.9512 29.1891 -14.7291 -26.607 12.32 -7377 6 43.6969 0.237019 22.6594 -7.19613 -4.49497 -5.57098 -7378 4 43.0237 0.783547 22.2316 -12.2242 -6.81623 2.03469 -7379 4 43.4415 41.2053 22.5454 5.15142 14.113 -1.35906 -7380 6 52.5052 40.9917 27.2414 -4.0762 -16.2903 -30.037 -7381 4 52.8129 40.7577 26.3208 -10.5132 10.5144 20.9332 -7382 4 53.295 41.2999 27.6882 6.37269 9.42971 1.77711 -7383 6 25.5785 23.9088 27.7352 -29.163 -0.147769 2.09076 -7384 4 24.7169 24.3904 27.6009 26.0068 -16.0483 4.45096 -7385 4 26.303 24.4711 27.4736 4.98376 5.99744 -3.44082 -7386 6 23.1322 17.0409 33.3147 -4.87562 4.34963 6.5261 -7387 4 23.1435 17.5188 34.1474 -0.665908 -2.26574 -1.07751 -7388 4 22.9237 16.1327 33.5379 -5.85649 -9.89669 4.05086 -7389 6 2.9235 11.8719 21.3628 -62.5775 -31.8178 -28.2901 -7390 4 2.1985 11.2347 21.6738 31.4392 30.9604 -16.9464 -7391 4 3.51176 11.9111 22.066 35.7266 4.49799 37.8533 -7392 6 2.17958 4.14491 30.0321 9.06251 -9.53771 -13.2585 -7393 4 2.15165 5.09682 30.107 -1.56529 16.7016 0.150815 -7394 4 2.7299 3.97467 29.2422 -7.5281 0.377543 4.10315 -7395 6 26.6694 30.2855 13.4776 10.1196 11.7228 27.7054 -7396 4 25.7357 30.4785 13.6549 -0.51692 -11.2356 -3.98914 -7397 4 27.0778 30.3597 14.373 -6.55394 -4.70072 -25.9179 -7398 6 24.8731 30.8123 10.8246 -35.9544 -8.06722 -7.65859 -7399 4 25.2097 30.0125 10.4324 5.41746 -9.73411 -7.41209 -7400 4 25.6149 31.228 11.1936 31.2673 18.7081 18.3938 -7401 6 53.1638 24.1184 4.51161 -10.4445 -35.9395 21.0824 -7402 4 53.5233 24.7957 3.98549 14.2054 30.1141 -21.0763 -7403 4 53.9237 23.6117 4.81383 2.71167 2.31883 7.09562 -7404 6 24.8958 4.51213 23.9931 -29.6363 -43.6073 15.3227 -7405 4 24.1339 5.1036 23.9039 18.5944 16.8193 -2.99678 -7406 4 25.7258 4.88904 23.7461 22.8138 27.5954 -9.18982 -7407 6 34.6838 1.65591 41.2514 12.8053 -23.083 -29.6978 -7408 4 35.6244 1.45761 41.0729 -14.4971 0.421146 -0.177754 -7409 4 34.7301 1.99199 0.211928 -2.47028 17.9107 34.9925 -7410 6 13.312 19.5249 16.387 18.9594 -19.3284 17.3248 -7411 4 13.9333 19.1674 15.7225 -9.24732 -4.9188 0.52103 -7412 4 13.2597 18.8166 17.0929 -3.23838 18.5958 -24.3952 -7413 6 48.698 0.181353 20.409 -0.21633 -26.9433 -24.4133 -7414 4 49.103 41.5184 19.698 -4.34753 24.5911 30.5043 -7415 4 48.7986 41.623 21.2469 8.80211 1.41451 -0.511645 -7416 6 43.0644 27.7916 11.5133 -14.5871 -6.12813 -9.0892 -7417 4 42.6 28.0105 10.6776 10.2055 -1.97818 11.3293 -7418 4 43.4908 28.591 11.8257 3.55806 4.66568 -1.20709 -7419 6 25.6909 21.365 35.1834 16.6334 21.4278 -26.2382 -7420 4 25.8486 22.0441 34.4664 -6.54449 -15.4554 28.1071 -7421 4 25.5413 20.5536 34.6727 -4.24699 7.33591 15.2905 -7422 6 44.7232 4.60607 27.7619 9.66663 0.618053 -4.25407 -7423 4 44.3234 4.00717 27.1079 -6.11804 2.34462 0.765623 -7424 4 44.3971 5.50639 27.5932 -3.06611 -6.30885 -0.545657 -7425 6 41.2897 11.4432 34.2066 -9.61739 21.0206 -8.56292 -7426 4 40.6842 11.5664 33.4581 3.14959 1.41378 -1.0752 -7427 4 41.1924 10.5195 34.3892 0.589219 -23.8889 7.33677 -7428 6 19.897 36.6492 2.04794 -32.5825 5.5481 -21.6378 -7429 4 20.6399 36.2361 2.4987 10.0826 10.558 0.716761 -7430 4 19.9026 37.6342 1.97212 14.9366 -15.8518 15.2433 -7431 6 27.4836 4.66736 6.35028 2.97665 -65.4375 -50.0742 -7432 4 27.6123 3.82169 6.79207 -3.46759 -4.72632 -9.32934 -7433 4 27.4741 5.24116 7.04108 -4.39889 64.7262 58.0755 -7434 6 16.8382 30.7844 39.9326 10.6925 -56.0648 15.7324 -7435 4 17.0186 31.2572 40.7403 -2.33579 15.7179 12.0581 -7436 4 17.0831 29.8382 40.1617 -5.04661 27.4351 -11.6424 -7437 6 51.1641 15.1933 16.3324 21.7581 16.0625 -9.079 -7438 4 51.121 16.0888 15.8936 10.5188 -25.5533 9.6052 -7439 4 52.0677 14.7794 16.1385 -37.3149 17.1399 3.28502 -7440 6 49.9904 21.2241 35.9744 20.9503 -33.7397 19.542 -7441 4 49.3714 21.5088 35.3291 -23.4605 10.1211 -23.8745 -7442 4 49.9121 20.2362 36.0002 2.40052 26.2853 0.00810801 -7443 6 34.428 0.14016 5.66944 -7.82493 37.3161 8.31948 -7444 4 34.304 0.843366 6.34479 2.68801 -11.9822 -16.4886 -7445 4 34.2591 0.582485 4.80419 9.04141 -16.6905 11.7821 -7446 6 48.3182 11.536 19.8764 -48.9228 13.3726 26.2823 -7447 4 47.7285 11.3649 20.663 34.2262 -2.74449 -19.9886 -7448 4 47.7235 12.1441 19.3775 23.4884 -14.873 -2.11476 -7449 6 4.19152 39.4305 13.3555 27.463 28.0369 44.5079 -7450 4 4.88401 39.7456 14.019 -21.6239 -15.7277 -33.754 -7451 4 3.37287 39.6897 13.8148 -3.76347 -10.7833 -11.4512 -7452 6 8.74995 16.191 8.53596 -5.05856 2.64204 -21.058 -7453 4 8.7323 16.8633 9.22906 0.669847 -0.203387 -6.91741 -7454 4 8.69158 16.6347 7.64451 3.76071 -7.46014 24.9197 -7455 6 29.0285 14.2822 26.5262 -5.84817 34.0816 17.5192 -7456 4 29.0044 15.2824 26.745 3.30971 -49.1818 -9.92417 -7457 4 28.1563 13.9159 26.7584 2.39554 12.59 0.416474 -7458 6 27.3852 14.5292 8.14264 -25.3608 8.37865 0.80053 -7459 4 26.4121 14.3996 8.08331 21.4517 0.6706 1.76752 -7460 4 27.495 15.4908 8.29449 3.73212 -17.2528 -1.50339 -7461 6 14.1265 27.2071 32.922 33.1666 19.82 -10.1122 -7462 4 14.9257 27.349 33.4618 -9.56175 -2.66902 -6.75133 -7463 4 13.49 26.8422 33.5082 -21.5238 -13.7689 15.9353 -7464 6 31.6534 35.7886 21.2701 -36.804 -37.663 0.546332 -7465 4 32.1208 36.3742 21.8378 9.4961 28.0075 13.3964 -7466 4 30.8651 35.4592 21.7961 25.8489 11.2411 -16.1565 -7467 6 54.2152 28.7064 16.8886 2.86275 11.2554 8.9719 -7468 4 53.522 28.534 16.2345 -0.160695 -4.94794 5.34414 -7469 4 54.0581 29.6054 17.2296 -4.68599 -7.1814 -6.41975 -7470 6 9.06113 5.28333 17.1437 22.8853 4.22723 -20.1716 -7471 4 9.91678 5.17464 16.6036 -37.1561 0.754494 23.2593 -7472 4 8.77829 6.22091 17.0709 7.89423 -13.2605 2.73354 -7473 6 29.6746 9.78112 26.5507 33.4729 -21.3737 16.6755 -7474 4 30.5187 9.26436 26.5785 -19.9088 14.0899 -1.39861 -7475 4 29.3838 9.79264 27.4752 -2.64272 0.36338 -0.771294 -7476 6 44.0224 31.1718 32.1785 -15.3292 -7.28341 -3.2168 -7477 4 43.2245 30.9732 32.7283 18.2556 6.42044 -7.39667 -7478 4 44.6106 31.7763 32.6435 0.791193 1.46174 13.5451 -7479 6 53.5017 3.62335 25.1421 -16.9806 -9.67341 -1.19546 -7480 4 54.1073 4.37139 25.2408 5.33888 -0.871569 -8.36925 -7481 4 53.4976 3.25444 24.2353 14.6771 10.8199 10.1585 -7482 6 12.4523 22.8699 3.37515 20.8696 32.0548 51.3092 -7483 4 12.8715 22.0381 3.24611 3.69599 -28.8916 -15.1378 -7484 4 11.7545 23.0169 2.77653 -28.9409 -2.61743 -32.5554 -7485 6 39.4163 29.6883 0.716973 23.965 14.7498 -4.51132 -7486 4 39.9876 29.0776 0.254063 1.0023 1.05593 -7.22278 -7487 4 38.7356 29.138 1.03498 -27.9991 -12.2746 11.9106 -7488 6 13.7523 37.8126 23.0391 19.0421 33.8918 15.0049 -7489 4 14.5819 38.1972 23.3968 -5.92503 -31.5844 -9.82397 -7490 4 13.2717 38.649 23.0641 -23.8611 -10.9328 -14.9892 -7491 6 33.3489 41.2294 0.00543 12.0778 19.0207 4.12226 -7492 4 33.8966 0.076279 41.545 -17.8654 -16.3366 26.9287 -7493 4 33.5442 41.0956 0.968664 -4.79835 4.63337 -24.688 -7494 6 15.7246 3.52046 6.32841 10.9162 -8.85937 41.3038 -7495 4 14.9211 3.23468 6.78447 -0.787572 2.77727 3.3355 -7496 4 15.4617 3.69817 5.45032 -11.5336 7.63209 -33.5323 -7497 6 27.7759 30.762 5.08277 5.52432 -34.0682 -16.3389 -7498 4 28.5998 30.6312 5.57248 -10.7862 7.58152 2.34054 -7499 4 27.6688 29.856 4.68367 -5.5152 22.3618 6.77689 -7500 6 13.3283 7.58248 23.3427 28.3072 -1.43357 14.0598 -7501 4 14.1858 7.86415 22.9596 -10.8574 -4.57961 9.77565 -7502 4 12.7328 7.50745 22.6198 -18.1881 0.025746 -17.8687 -7503 6 38.3062 37.3234 27.9933 -3.63803 -3.21002 47.0561 -7504 4 38.1692 37.3862 27.0673 7.32148 -0.46048 -39.7323 -7505 4 39.0245 36.7163 28.2248 2.26391 -1.88339 -8.27891 -7506 6 35.8197 12.5511 12.093 -4.81482 -18.6185 14.0356 -7507 4 35.6024 11.6096 12.0486 2.81432 1.21601 -0.921604 -7508 4 36.2712 12.7262 11.2865 10.3444 9.98072 -18.0035 -7509 6 52.1161 23.0926 41.2793 27.7225 -3.87143 -59.8556 -7510 4 52.4049 23.0393 40.2964 5.44511 3.0042 51.4604 -7511 4 51.1968 22.9093 41.149 -26.7248 -2.75497 17.7375 -7512 6 39.5495 11.6692 16.6079 -1.17202 -14.5197 -14.1262 -7513 4 39.7784 10.7494 16.7482 7.99576 -7.98247 -12.1867 -7514 4 39.4663 11.9292 17.5115 -4.38422 20.0879 20.6825 -7515 6 0.676885 9.01905 7.96736 13.1741 22.7352 -22.4375 -7516 4 54.8016 8.92404 8.29683 -40.226 7.08621 2.19233 -7517 4 1.10058 8.31451 8.38908 28.7575 -30.4684 16.9583 -7518 6 42.3311 28.7401 39.4661 13.4879 80.877 11.2525 -7519 4 41.6603 28.5849 40.0851 -34.7426 -11.2721 27.5092 -7520 4 42.5519 27.921 39.1558 20.2132 -66.4303 -37.3003 -7521 6 38.7411 30.2829 16.2738 12.7671 5.32399 18.4704 -7522 4 38.9183 29.8748 17.1496 -6.87016 4.31697 -11.6029 -7523 4 39.4059 31.0046 16.2472 -14.9795 -12.5163 -3.03567 -7524 6 7.58764 18.0405 0.648325 -47.6574 -19.7672 20.3632 -7525 4 7.12731 17.6217 1.42737 12.1211 9.19751 -27.5752 -7526 4 8.47251 18.0259 0.938181 42.7013 4.4664 8.86021 -7527 6 33.7296 34.5938 24.1405 -3.484 -2.51034 -8.30179 -7528 4 33.5251 35.3309 23.5532 1.13599 -1.72579 4.26838 -7529 4 33.8994 34.9649 25.0137 6.47563 -1.63099 1.09862 -7530 6 16.0166 40.0494 39.5956 -28.3908 0.329345 -1.37751 -7531 4 16.9382 40.2323 39.4336 17.0381 0.329941 -6.23981 -7532 4 15.5262 40.0524 38.7513 12.3223 -0.591958 2.13513 -7533 6 4.49229 37.1333 21.8385 27.3085 -52.2253 -58.5501 -7534 4 4.66683 37.716 22.5264 18.8147 38.5231 40.56 -7535 4 5.37915 36.8768 21.3985 -41.7208 12.465 14.7942 -7536 6 39.2691 20.1288 31.3316 -12.2203 -9.20146 -18.9279 -7537 4 39.1503 20.9416 31.8094 1.95478 16.2675 16.373 -7538 4 38.6746 20.1785 30.5607 4.99665 9.53371 7.24081 -7539 6 28.5508 6.16368 32.0494 2.8072 -5.52183 -6.01527 -7540 4 29.3622 6.49582 32.4253 9.65206 -4.8896 7.96618 -7541 4 28.0782 6.98121 31.874 -4.3704 -0.58129 1.95425 -7542 6 9.33595 11.3298 38.1871 -32.8874 9.84086 11.8913 -7543 4 8.64445 12.0594 38.2922 21.8008 -26.7714 -10.0524 -7544 4 8.88851 10.5546 37.784 7.69784 20.5749 -6.72048 -7545 6 41.6095 10.4782 6.86111 8.23897 -6.62675 34.9169 -7546 4 41.7694 10.1037 7.78655 -4.1265 15.4661 -32.721 -7547 4 41.7821 11.4382 6.90291 -3.49967 -11.9299 -5.09907 -7548 6 3.12867 28.1157 17.6206 15.6267 -45.6796 29.9202 -7549 4 2.63816 28.6493 17.0564 -29.7899 29.6493 -43.0934 -7550 4 3.59757 28.7421 18.155 7.53462 9.15161 11.5693 -7551 6 39.3499 12.2397 19.2529 -23.7838 14.9837 13.9357 -7552 4 39.2457 13.2286 19.3464 7.91877 -27.4185 3.68816 -7553 4 38.6075 11.8387 19.7677 15.6586 5.94778 -12.3856 -7554 6 2.78491 9.11686 31.712 -26.5503 -22.4732 34.9375 -7555 4 3.2978 8.41451 32.2045 -9.27186 19.8876 -17.5091 -7556 4 3.27525 9.5282 31.0263 27.6548 6.40843 -16.0242 -7557 6 47.0993 34.3062 24.1668 40.213 25.5871 3.96938 -7558 4 47.8652 34.9011 23.9742 -8.40565 -28.0457 9.8184 -7559 4 46.4391 34.8642 23.795 -37.1496 -1.08965 -6.28687 -7560 6 41.29 35.6184 9.54316 -30.0867 29.8286 7.21591 -7561 4 40.3249 35.7138 9.72984 17.4159 -14.0538 -3.31523 -7562 4 41.5907 36.542 9.70742 6.71087 -21.892 -10.0971 -7563 6 20.4656 31.4513 3.14505 -29.4444 2.15246 21.5865 -7564 4 20.9799 31.2087 3.9226 8.79014 -0.482357 -2.15716 -7565 4 19.5517 31.5947 3.51954 23.5031 -1.57475 -20.844 -7566 6 33.2192 17.965 24.7971 19.8065 25.0952 18.1835 -7567 4 34.1598 18.0267 25.093 -16.2559 -11.4614 -7.96855 -7568 4 32.9244 18.9016 24.8301 -6.14071 -21.8705 -2.46334 -7569 6 40.1545 39.892 35.7566 -26.4952 1.03865 35.1005 -7570 4 39.554 39.7115 35.0283 3.12548 3.08468 -2.58895 -7571 4 39.5538 40.0617 36.55 23.7339 -1.54775 -30.4418 -7572 6 4.86493 34.7165 16.5037 -1.18866 4.83191 -8.79653 -7573 4 4.98021 35.6639 16.3239 -2.48039 -7.07182 -3.79473 -7574 4 5.57973 34.27 16.0245 9.17482 -2.77359 5.31354 -7575 6 19.1203 11.0308 26.5475 4.8369 12.9311 -1.38474 -7576 4 19.2948 10.8261 25.6303 -10.7878 -2.53157 -9.81197 -7577 4 19.6222 10.3806 27.0285 -0.932765 -12.0852 11.9627 -7578 6 54.013 13.9266 34.7866 19.735 -12.4153 18.0126 -7579 4 53.1377 14.0488 35.1524 -10.4928 -1.09871 -13.0068 -7580 4 53.982 14.1469 33.8595 -3.66316 10.2302 -11.2602 -7581 6 1.83695 20.649 5.20524 25.5491 14.9074 -17.0883 -7582 4 1.35705 19.8566 4.90021 2.5306 9.60758 -2.11708 -7583 4 2.48138 20.9466 4.48633 -27.5057 -15.388 16.1855 -7584 6 22.2484 0.089789 14.2543 15.3573 -11.1234 0.0573231 -7585 4 21.4821 0.622149 14.4313 -9.66168 8.29964 10.305 -7586 4 22.7606 41.8363 15.0657 -14.7435 5.42194 -5.09127 -7587 6 4.9437 7.03924 24.7311 13.2528 -2.19763 7.32506 -7588 4 4.13251 7.3412 24.2993 4.98795 -3.92941 -4.4547 -7589 4 5.31694 6.26419 24.274 -9.7854 5.58222 5.45409 -7590 6 41.4768 20.8727 34.9433 -10.8141 32.3245 17.6117 -7591 4 42.0721 20.1596 35.0936 18.2074 -21.2429 -2.25611 -7592 4 41.5511 21.3995 35.7803 -3.93981 -14.5735 -18.4651 -7593 6 28.2063 1.73787 31.7361 2.56856 -6.63991 -21.6427 -7594 4 27.5833 1.04583 32.0206 5.931 11.5306 2.70007 -7595 4 28.427 2.28487 32.4907 -6.15569 2.19681 12.1249 -7596 6 16.8959 27.3728 36.9936 3.36683 -9.46076 -21.7251 -7597 4 17.1861 28.0765 36.4018 -0.835984 6.87178 9.62195 -7598 4 17.1491 26.5677 36.4964 -8.72142 5.45523 11.8618 -7599 6 26.8172 38.095 8.33253 -7.04389 15.4319 43.7153 -7600 4 26.4231 38.1886 9.22965 13.1827 16.4204 -18.9623 -7601 4 26.752 37.1697 8.26194 2.82704 -45.8494 -18.5449 -7602 6 26.6605 33.8021 23.2109 -14.7721 -8.40788 6.86704 -7603 4 27.1437 33.2455 22.6071 1.71839 -3.83047 -13.3917 -7604 4 27.3181 34.0928 23.8234 13.6598 11.6313 12.8928 -7605 6 10.2089 27.1103 30.2249 26.5091 -20.839 -19.8889 -7606 4 10.2296 28.0525 30.305 -4.35446 23.414 7.17464 -7607 4 10.909 26.9135 29.5485 -17.3927 5.996 19.4297 -7608 6 47.8678 12.6068 5.01236 10.3402 17.2727 14.3835 -7609 4 48.2471 13.4466 5.34357 -15.5974 -13.1618 -9.91905 -7610 4 48.2827 11.9587 5.58273 0.760146 -12.24 2.37579 -7611 6 53.3401 24.5564 22.1447 -33.4845 3.13007 15.4457 -7612 4 53.2868 24.6175 23.1082 -8.50106 -5.88574 1.47389 -7613 4 54.2491 24.6404 21.954 37.9576 4.9603 -12.0283 -7614 6 29.4115 10.751 19.3682 47.3718 16.1602 -3.46693 -7615 4 29.23 9.95501 18.9095 -1.62259 -22.6341 -18.5903 -7616 4 28.6164 10.8767 19.816 -47.8248 15.8998 30.722 -7617 6 39.4772 14.9486 19.552 50.4126 11.9025 42.2912 -7618 4 40.3976 15.2789 19.8627 -47.7598 -21.1435 -8.50237 -7619 4 39.4723 15.2512 18.6704 -12.4406 15.8155 -35.6919 -7620 6 32.8813 15.9868 22.8125 3.47488 17.0872 -31.9433 -7621 4 33.0166 16.4922 23.6113 -1.39335 7.20309 14.6349 -7622 4 32.7144 15.0846 23.0256 -4.37432 -22.045 19.0968 -7623 6 30.558 1.96704 21.5074 2.70654 -4.91402 -0.473851 -7624 4 30.6739 2.00523 22.4671 5.88049 3.20632 -1.97238 -7625 4 31.3728 1.59666 21.1136 -11.8747 6.17773 7.16567 -7626 6 0.976021 12.0022 3.31788 -2.33791 2.9975 -11.3542 -7627 4 1.23381 12.945 3.27167 -8.13702 -10.1344 5.41434 -7628 4 1.05317 11.6593 4.21576 7.83216 6.74936 8.77967 -7629 6 32.1417 30.4028 20.7928 -10.9162 7.90477 -12.8705 -7630 4 32.9583 30.6218 20.3315 4.32484 3.35409 -0.814586 -7631 4 31.4267 30.7883 20.2371 10.7836 -11.8724 10.7529 -7632 6 5.37233 35.5196 8.9984 1.65786 -0.655334 17.0686 -7633 4 5.15633 35.7733 8.10502 -8.52999 -6.98357 -10.434 -7634 4 4.86772 34.7263 9.2434 -1.9757 2.02155 -6.9424 -7635 6 49.9125 13.0387 32.1973 27.4626 15.6741 -16.8517 -7636 4 50.6053 12.9182 31.4733 -26.2683 -0.306922 26.3637 -7637 4 49.2504 12.3613 32.0764 -3.75185 -11.6573 -0.304044 -7638 6 4.31386 24.093 1.57868 7.45772 -24.8618 -14.5348 -7639 4 3.64218 24.7342 1.7864 -13.9986 8.43803 -2.25361 -7640 4 4.01488 23.4668 0.872394 2.3276 24.3041 16.4513 -7641 6 44.1644 38.1215 12.3455 -22.0907 -25.3739 20.9172 -7642 4 43.5152 37.5597 12.8481 16.1408 4.83783 -17.5332 -7643 4 43.8688 38.9961 12.5721 5.21907 21.319 -3.3764 -7644 6 44.6817 17.3326 22.8013 48.0619 -4.56356 -9.07637 -7645 4 45.2902 18.0584 23.1498 -22.5072 -22.7727 -5.21409 -7646 4 45.2932 16.6008 22.4593 -20.015 30.0459 19.1644 -7647 6 20.3678 11.7042 19.6638 18.1083 -41.9451 -24.672 -7648 4 19.8947 12.3606 20.1264 -14.0753 36.8205 14.9866 -7649 4 20.5011 12.0109 18.7433 -0.799123 0.72776 10.7716 -7650 6 4.45477 15.3976 36.1886 1.65809 1.26145 11.9226 -7651 4 5.09661 14.6681 36.098 -4.75494 5.61497 -10.92 -7652 4 3.56051 15.0123 36.2095 4.93474 0.57137 -3.51241 -7653 6 44.8032 39.5214 30.1736 10.2403 3.65831 -28.7798 -7654 4 44.6649 39.352 29.2044 0.893291 -3.4354 28.9244 -7655 4 44.1834 39.0261 30.7164 -9.9549 -0.503639 -4.51595 -7656 6 30.0776 3.52093 11.3186 -8.111 -9.63673 -5.93937 -7657 4 30.5797 4.33725 11.0789 -10.9699 -19.7375 -4.73534 -7658 4 29.9808 2.85663 10.5812 14.022 21.906 10.2093 -7659 6 25.6241 24.8658 16.1333 6.68449 -9.57605 -29.1286 -7660 4 26.5694 24.8046 15.8818 -8.72523 1.1772 17.1704 -7661 4 25.5267 25.1318 17.0381 12.8553 5.85519 26.3055 -7662 6 36.8177 29.8487 20.6561 -37.5479 -3.0004 33.0202 -7663 4 35.926 30.1959 20.4157 18.2985 -1.907 -0.407745 -7664 4 36.6716 29.3784 21.5423 12.7247 15.2026 -39.3319 -7665 6 52.2186 17.0658 38.3042 -7.89215 -38.4825 28.5148 -7666 4 51.4916 16.4675 38.6484 24.7832 21.5941 -14.95 -7667 4 51.8247 17.6139 37.6469 -10.8917 8.73986 -12.7264 -7668 6 3.82879 23.6249 29.8747 0.0111461 24.9347 -0.194649 -7669 4 4.57266 23.2964 29.3507 7.82142 7.55197 5.89536 -7670 4 4.12107 24.4472 30.3626 -2.93665 -31.334 -6.69289 -7671 6 6.37221 19.8955 41.0814 -10.7405 10.6187 0.232117 -7672 4 6.67124 19.2607 41.7286 9.67887 -12.4754 3.81392 -7673 4 6.49825 20.7419 41.4991 -1.14685 10.1205 10.9238 -7674 6 28.9128 38.9237 35.3305 22.4394 21.6131 25.3888 -7675 4 28.4594 38.2476 34.8641 -13.9867 -26.2755 -20.0992 -7676 4 29.711 38.4973 35.7105 -10.7836 3.83713 -8.57645 -7677 6 1.06675 30.3059 34.4729 25.4378 -4.31804 35.0042 -7678 4 0.780778 29.8064 33.7399 -5.76855 -22.7951 -38.2413 -7679 4 0.490797 31.0506 34.5199 -18.1513 16.5028 -0.872558 -7680 6 26.4359 22.0299 20.4363 32.8101 13.5123 0.44111 -7681 4 27.364 22.3315 20.3938 -13.8894 -16.1779 0.0777322 -7682 4 25.9647 22.8561 20.3336 -19.4369 -2.2953 -2.32927 -7683 6 3.94837 18.6341 22.6823 32.7056 -17.0211 23.8668 -7684 4 4.7768 18.6814 23.2391 -24.3494 -8.73456 -16.7413 -7685 4 3.72444 19.5457 22.6416 -13.4357 33.3979 -9.86072 -7686 6 6.89585 39.3162 26.9832 -46.5714 7.68979 7.72716 -7687 4 6.93923 40.0377 27.612 28.7888 3.33438 12.9127 -7688 4 5.92214 39.2413 27.0287 16.4173 -5.75108 -11.0421 -7689 6 43.9872 41.7521 26.5322 17.8857 -12.0416 -16.5154 -7690 4 43.9509 0.2718 27.3768 -8.40653 9.77536 19.5266 -7691 4 43.1315 41.809 26.1188 -22.0408 9.50446 -3.00799 -7692 6 31.7113 29.5746 16.987 -20.6637 1.93471 5.13032 -7693 4 31.02 28.863 17.0135 12.5534 15.6398 -7.64726 -7694 4 31.2508 30.4156 17.2234 10.2038 -24.3383 2.42367 -7695 6 46.2561 10.9612 15.5385 0.577538 -38.7584 22.3134 -7696 4 45.3251 10.7213 15.4484 -5.02058 7.03855 -0.171485 -7697 4 46.6569 10.0824 15.7727 -2.20865 28.2857 -11.3723 -7698 6 36.5827 15.0435 25.8168 31.2067 4.61936 9.12499 -7699 4 37.3875 15.5118 26.1911 -33.209 -18.98 -14.6655 -7700 4 36.1295 14.6889 26.5897 -4.0863 -6.05063 3.58839 -7701 6 47.2722 22.6647 6.13576 -8.17133 27.0247 -35.749 -7702 4 46.6204 23.3224 5.77393 14.8224 -22.4366 13.8178 -7703 4 46.9842 22.4705 7.01441 -4.98592 -2.25738 16.061 -7704 6 27.5378 39.6651 17.8024 -2.94112 10.9701 -10.3343 -7705 4 26.5953 39.7232 17.618 -8.53785 1.10642 -8.0722 -7706 4 27.5664 39.1005 18.5557 5.38052 -12.9364 18.2146 -7707 6 14.0357 27.9675 36.8848 11.7171 -39.9071 2.25396 -7708 4 13.4367 27.1833 36.8225 11.7441 28.4062 -4.63591 -7709 4 14.9372 27.5486 36.8957 -17.1932 18.8386 1.76957 -7710 6 33.7684 13.0304 13.8649 26.1794 -24.2655 -33.187 -7711 4 34.6252 12.938 13.363 -28.3858 22.7045 20.1179 -7712 4 33.4338 12.1329 13.7478 -6.61414 4.24237 14.4002 -7713 6 3.3826 17.477 1.97134 -12.4208 -32.1468 -36.6933 -7714 4 2.99872 16.7111 1.40376 19.9781 39.313 29.0042 -7715 4 3.44044 18.2025 1.33186 0.336883 0.1642 8.16047 -7716 6 27.5407 2.76347 36.4361 37.1152 10.6125 -5.75272 -7717 4 28.1274 2.95293 35.6781 -8.18971 -2.06925 12.0999 -7718 4 26.7696 2.41682 36.0063 -15.232 -6.73967 7.66134 -7719 6 21.3092 1.20818 18.7198 27.6808 -56.7894 17.4302 -7720 4 20.9088 2.03925 18.6129 -17.8717 42.912 1.2548 -7721 4 21.1846 0.863131 19.6413 -10.5106 12.8119 -18.3621 -7722 6 11.8887 16.6751 29.3062 -13.3787 -14.7829 9.57092 -7723 4 10.9992 16.5416 28.8882 19.0949 3.10928 11.6713 -7724 4 11.8781 16.1991 30.1864 -3.15773 18.3703 -25.9576 -7725 6 15.9606 29.4505 29.6321 19.1231 40.0535 19.8704 -7726 4 16.8787 29.2659 29.409 -1.79459 -0.812108 -5.15406 -7727 4 16.0576 30.3074 30.1528 -10.887 -31.0851 -11.0284 -7728 6 42.9296 7.03459 4.51333 33.3286 4.63812 8.33203 -7729 4 43.4321 7.52085 3.82302 -14.3213 -8.56549 9.51251 -7730 4 43.6462 6.74019 5.1384 -26.8219 -5.28882 -15.1101 -7731 6 46.4281 26.3352 18.5118 -29.5226 20.9834 -10.3716 -7732 4 46.6343 27.1839 18.9751 -0.829481 -30.2492 -9.82569 -7733 4 45.6684 26.5824 17.9287 20.9241 -8.5113 7.46212 -7734 6 26.8394 31.9326 30.1088 25.5924 -16.6135 -32.4851 -7735 4 27.2107 31.0232 29.8435 -20.3392 35.4128 12.4615 -7736 4 26.6802 32.4017 29.2373 1.48159 -21.8349 29.7067 -7737 6 19.4878 37.6142 31.2562 -14.4543 3.58951 24.8148 -7738 4 19.156 36.8698 30.7235 -3.28844 3.66685 11.8368 -7739 4 19.1019 37.6358 32.1884 8.87174 -10.6544 -29.6345 -7740 6 52.3726 32.7139 12.8078 14.0751 37.5782 -32.6023 -7741 4 51.9367 33.0602 12.0031 -5.44932 -19.1877 9.81768 -7742 4 53.2329 33.1776 12.7347 -13.6236 -17.9256 14.0183 -7743 6 6.74161 9.28353 24.0307 -13.1667 -36.0519 9.75632 -7744 4 6.38029 9.61276 23.1997 0.718458 -3.76261 -6.90188 -7745 4 6.16941 8.51095 24.2946 11.6474 19.2019 -8.42102 -7746 6 39.7455 39.5612 25.4988 -8.346 1.54154 -0.59194 -7747 4 39.7035 38.6168 25.2826 0.975023 6.38379 0.651723 -7748 4 38.8484 39.7767 25.8082 2.0142 -6.85885 -0.770105 -7749 6 24.0762 14.0053 21.1456 13.3165 -18.5501 -35.6859 -7750 4 23.5798 13.5675 21.8237 -9.9014 -1.44375 19.5869 -7751 4 24.3047 13.2647 20.5221 -3.72657 29.1491 15.9401 -7752 6 5.19759 41.7876 24.8616 10.5329 -30.3401 13.9713 -7753 4 5.96107 0.070496 25.4117 5.01198 -1.48177 -8.04364 -7754 4 4.80364 0.70791 24.6471 -6.87058 19.426 -10.6286 -7755 6 42.3635 20.8692 21.2747 32.7502 -34.6644 -10.1673 -7756 4 42.4242 20.4785 22.1458 -3.583 2.66194 10.2144 -7757 4 41.7418 21.5604 21.318 -29.6652 28.4695 2.24145 -7758 6 48.2477 15.3659 33.5923 1.80889 -1.28345 12.5443 -7759 4 48.6164 14.6993 32.9992 0.330488 0.612282 -4.05403 -7760 4 47.6342 15.9182 33.1009 -4.13716 0.340872 -13.8372 -7761 6 46.021 38.2915 16.5867 23.3569 13.4435 24.034 -7762 4 46.6714 37.7063 17.0526 -15.1447 15.3639 -15.4724 -7763 4 46.2171 39.2064 16.9307 -10.1858 -20.2136 -16.2853 -7764 6 4.64649 28.484 21.3661 -49.4423 -36.8464 -34.122 -7765 4 5.0061 28.857 22.1388 17.5694 9.2675 37.6073 -7766 4 4.11403 27.6656 21.6036 24.8595 24.6655 -3.1651 -7767 6 20.5601 15.1658 18.389 17.6685 -18.4833 12.4376 -7768 4 20.0269 15.9148 18.1339 -10.4277 9.01273 0.992097 -7769 4 20.1375 14.696 19.1318 -1.87864 11.9594 -2.12399 -7770 6 16.2536 13.648 17.4664 -31.6255 -3.12789 -19.3987 -7771 4 16.1444 14.6075 17.6118 2.65347 -13.1818 -8.15029 -7772 4 15.6032 13.3943 16.7283 22.0135 11.6863 31.5082 -7773 6 52.4969 30.9511 18.1582 10.5176 -22.8935 27.2955 -7774 4 52.1187 31.5845 17.5724 -17.5669 13.4893 -21.7562 -7775 4 51.7599 30.5669 18.6706 14.518 10.6779 -8.97027 -7776 6 24.417 1.73185 15.7818 -6.46311 -4.24469 33.4298 -7777 4 24.2563 1.19981 16.5985 3.98325 2.24538 -18.7421 -7778 4 24.1038 2.61269 16.0335 4.13298 0.832539 -9.96215 -7779 6 23.8696 5.09384 31.0808 18.8621 -40.8234 -26.8653 -7780 4 23.8491 5.89936 31.5593 0.144588 30.2314 14.3891 -7781 4 24.8063 4.82715 30.9043 -17.3015 12.7186 6.18451 -7782 6 29.664 30.9246 0.393748 19.8337 -4.81556 23.0674 -7783 4 30.503 30.586 0.018652 -21.3617 6.75777 -1.54054 -7784 4 29.144 31.3327 41.6109 -5.17979 -0.628515 -14.2195 -7785 6 32.8496 37.8945 22.5158 10.0753 4.77658 10.1953 -7786 4 33.692 38.178 22.1563 2.67507 -3.41774 -7.7275 -7787 4 32.953 38.1222 23.4459 -10.6691 2.21895 5.00606 -7788 6 16.4801 17.3789 33.7607 -9.23434 -4.14589 -23.771 -7789 4 15.9446 17.8653 33.093 7.5539 3.01496 23.5583 -7790 4 17.136 16.9338 33.2029 1.0053 3.7812 3.66748 -7791 6 9.22576 13.3955 27.544 21.8484 -6.91303 -4.28818 -7792 4 8.36976 13.4851 27.1157 -15.2219 0.444174 10.4645 -7793 4 9.14931 12.9772 28.4181 -9.36318 7.36421 3.71477 -7794 6 43.4776 7.7356 17.2334 -9.59035 3.82748 19.1182 -7795 4 43.4092 7.74545 18.2218 0.501649 1.62452 -33.0026 -7796 4 44.4173 7.85634 17.0579 0.99974 -1.57098 -4.99047 -7797 6 22.314 24.3423 23.1668 -12.6246 5.51695 -1.93377 -7798 4 22.7955 23.5193 23.2443 6.83464 -10.1031 3.26418 -7799 4 21.5276 24.1384 22.6266 3.35813 5.31764 3.82921 -7800 6 26.0086 32.9187 32.7195 -0.756619 6.65713 -1.20686 -7801 4 26.2515 32.7095 31.8047 -0.82286 -4.52018 -0.557583 -7802 4 25.2078 32.4163 32.9092 -2.81033 -0.378904 -0.617388 -7803 6 16.9305 19.0463 7.44765 14.0068 18.7364 -6.96389 -7804 4 16.3855 19.2981 8.21028 -2.47769 1.30563 -6.88861 -7805 4 17.0815 19.8512 6.87677 -9.59141 -23.4241 18.196 -7806 6 48.1118 14.458 27.5672 -1.70385 5.14823 10.3583 -7807 4 48.0423 15.1786 26.9235 1.90686 -4.78611 -1.19899 -7808 4 48.0875 14.8765 28.4507 4.89589 -0.740891 -11.823 -7809 6 52.3863 41.7399 11.1185 2.41988 14.2085 23.7397 -7810 4 52.3863 0.193993 10.2459 -4.45976 10.8931 -22.0542 -7811 4 52.6887 0.557857 11.7005 -5.56281 -10.4239 -7.84704 -7812 6 36.3311 6.93589 12.7094 -2.38398 9.53491 -1.97617 -7813 4 36.3789 7.90344 12.827 -2.48918 -10.7733 3.15906 -7814 4 37.2588 6.6822 12.6726 5.22435 -7.00461 -0.877062 -7815 6 8.24215 20.3216 16.6719 4.98767 -5.10439 -5.65687 -7816 4 8.08588 19.3952 16.4038 -4.3079 5.82994 10.8424 -7817 4 9.2046 20.4438 16.7199 -1.30961 -3.63404 -4.19262 -7818 6 28.7954 40.3113 12.828 -13.6179 6.23593 21.4452 -7819 4 29.5192 40.3706 12.2287 20.8327 -7.3113 -16.8089 -7820 4 28.5554 39.3777 12.9053 -3.26344 4.60902 -2.65931 -7821 6 18.1473 11.8343 16.9395 -0.80483 -16.2761 12.6256 -7822 4 17.6848 12.6388 17.2294 4.62203 -2.59462 -3.9508 -7823 4 19.0947 11.9922 16.9221 7.13726 16.095 1.27241 -7824 6 30.8869 17.4142 21.504 -52.7305 12.2285 -31.3088 -7825 4 30.1482 16.8222 21.1884 27.1221 10.2955 22.0665 -7826 4 31.6253 16.8731 21.7262 19.9221 -18.6281 13.9623 -7827 6 34.8012 19.4194 37.9626 16.1869 22.0253 -15.6613 -7828 4 34.8979 20.1386 37.2822 -2.41662 -18.1877 20.3873 -7829 4 34.2105 18.7604 37.6043 -6.15487 -8.04615 -10.7113 -7830 6 35.8208 16.8923 29.2032 22.3367 20.7443 33.8648 -7831 4 36.613 16.5252 29.6466 -9.20578 0.119567 -6.22754 -7832 4 35.5382 16.2441 28.5922 -11.4717 -30.451 -21.7041 -7833 6 3.04279 32.2854 6.33929 -26.9238 12.3825 -4.69033 -7834 4 2.12647 32.146 6.0594 1.42689 6.59766 6.64942 -7835 4 3.42261 31.4611 6.08203 25.9982 -20.506 -0.598367 -7836 6 26.7966 41.6596 10.1464 32.6739 -10.8326 9.81865 -7837 4 27.6955 41.4226 9.79016 -25.5431 4.71255 4.81996 -7838 4 26.9918 0.01593 11.0584 -5.4334 2.64263 -3.14356 -7839 6 52.266 24.562 24.8685 -9.42886 0.421982 -6.72882 -7840 4 51.3046 24.7615 24.9057 17.7877 -5.82089 5.23086 -7841 4 52.6568 24.8699 25.6923 -4.67896 5.24225 9.60646 -7842 6 22.6938 22.6511 33.5751 -3.71591 7.58927 38.5179 -7843 4 23.2073 23.1628 34.2375 -1.81825 -3.74423 -24.5931 -7844 4 21.9227 22.4274 34.1227 -1.3969 -6.37714 -14.1968 -7845 6 10.6508 14.2453 33.0462 38.3111 -19.1724 1.31243 -7846 4 10.5904 14.9583 32.4175 -11.7628 10.624 -9.61146 -7847 4 9.79743 14.0525 33.3881 -28.4056 0.15536 2.16046 -7848 6 21.8963 10.8464 11.5207 26.0054 2.65771 10.2946 -7849 4 22.8204 10.615 11.7238 1.04479 5.32162 -7.74354 -7850 4 21.5123 10.8483 12.397 -14.7134 -4.5627 10.8449 -7851 6 38.3602 6.02493 25.8481 -1.65407 -6.16467 0.326828 -7852 4 38.011 6.16356 26.7557 4.19059 11.4538 -13.8011 -7853 4 38.4332 6.8537 25.3449 -2.0709 2.94932 12.5244 -7854 6 30.9335 26.6426 38.5759 12.2579 -6.52521 -50.146 -7855 4 30.9725 26.4832 39.4983 -1.12433 -12.3748 34.5417 -7856 4 31.1634 25.7976 38.1184 -10.2303 12.0451 18.6771 -7857 6 30.1758 14.6176 35.4883 -28.0954 45.5198 -22.6945 -7858 4 30.377 15.4621 34.9933 16.3957 -28.3235 8.82257 -7859 4 29.2055 14.6893 35.4544 11.1506 -16.8188 10.9927 -7860 6 12.5393 37.2199 16.9523 -39.8589 -5.36999 -7.27655 -7861 4 12.8749 37.9509 17.4338 22.3846 22.4284 20.6781 -7862 4 13.1653 36.5135 16.9845 23.2041 -13.3789 -0.375674 -7863 6 27.4265 21.5607 37.7225 20.8747 -12.9562 -0.181201 -7864 4 26.9326 21.725 36.9211 -12.0211 3.79264 -7.84561 -7865 4 27.0206 21.994 38.4656 -12.5008 8.35973 2.85409 -7866 6 29.6119 18.3909 12.6766 5.02953 -16.5769 27.1188 -7867 4 29.5217 18.1084 13.6179 -1.01954 6.11509 -19.9302 -7868 4 28.7057 18.4542 12.3734 -9.03627 4.70036 -1.08008 -7869 6 2.35849 15.6559 0.172343 -13.1317 26.5324 40.4931 -7870 4 1.57628 15.538 41.5798 -33.9312 2.46749 -10.4392 -7871 4 2.94928 15.1153 41.6306 46.9044 -35.3027 -23.6199 -7872 6 17.8239 25.728 4.21905 -37.6117 -8.49993 -31.7596 -7873 4 16.8718 25.6243 3.8952 33.4499 1.9374 22.526 -7874 4 18.2969 25.7387 3.3671 7.88894 5.9968 18.5236 -7875 6 41.8048 11.1855 20.2736 -2.74436 -4.31591 -6.39865 -7876 4 42.499 11.3266 19.6063 -2.31748 -7.213 6.47037 -7877 4 40.9812 11.3277 19.7997 -4.16553 7.78699 0.129723 -7878 6 38.0436 18.3822 24.0291 -8.03771 -8.75406 0.916934 -7879 4 38.3881 19.1147 24.5363 7.93091 8.32946 7.65245 -7880 4 37.8775 18.7197 23.1534 1.15748 3.59885 -9.88254 -7881 6 4.13949 13.9245 33.751 32.8429 -54.5446 -5.73928 -7882 4 3.27676 13.674 34.0388 -19.3763 3.63281 4.9893 -7883 4 4.61955 13.0097 33.6871 -20.752 50.0513 -2.76975 -7884 6 19.1955 19.1942 26.4999 -2.68794 -13.6734 16.0889 -7885 4 19.5301 20.0447 26.2113 2.49975 9.05121 -5.4902 -7886 4 18.8802 18.7176 25.7363 0.91839 -0.338605 -10.966 -7887 6 22.4654 26.212 25.3377 -43.9819 -31.3945 15.8492 -7888 4 22.341 25.462 24.7348 6.987 2.92742 -4.90062 -7889 4 23.2684 26.6111 25.1223 47.0594 15.091 -19.0516 -7890 6 48.8212 32.07 32.5598 -32.6217 13.0764 9.49579 -7891 4 48.8519 31.1339 32.3903 9.77015 -16.5586 -2.94571 -7892 4 49.6142 32.4858 32.2593 19.8009 3.1546 -7.06015 -7893 6 25.2092 18.0177 27.0119 4.84672 -18.7822 -3.15467 -7894 4 24.5216 17.4674 27.4199 2.41306 12.0417 3.55819 -7895 4 25.6695 17.4202 26.3966 -2.25094 9.61905 1.21472 -7896 6 1.75029 41.5558 24.9373 10.8929 -9.66126 -16.5331 -7897 4 1.94143 40.8029 24.3062 -11.1729 27.8661 22.017 -7898 4 1.33214 0.330238 24.3814 7.15774 -16.2959 10.6574 -7899 6 18.6827 11.7655 10.8523 -12.8723 -21.6642 16.1997 -7900 4 19.5636 11.9042 10.4948 -5.12175 -0.337419 -4.96303 -7901 4 18.6779 10.8452 11.2231 -2.76434 23.9208 -10.2934 -7902 6 45.6216 16.5622 4.85345 35.2391 7.72621 -8.96994 -7903 4 46.5826 16.2921 4.84248 -29.2944 1.01327 2.32041 -7904 4 45.6571 17.5026 4.56372 -8.00263 -16.2723 6.75488 -7905 6 40.6693 36.3938 24.0175 15.8353 8.34465 -33.37 -7906 4 40.8833 36.7626 23.1096 -14.2319 -6.57786 31.0793 -7907 4 40.765 35.4388 23.9669 -2.25062 -4.28397 3.06966 -7908 6 32.2103 36.323 4.961 11.3673 -15.0032 -27.5021 -7909 4 31.6022 36.0041 4.27996 -13.8963 14.3234 5.17466 -7910 4 32.9864 35.7931 4.73143 4.05858 7.46319 17.1387 -7911 6 1.60869 14.6755 10.8061 -10.0389 6.06769 39.8197 -7912 4 2.33356 15.3221 10.9109 -7.21973 -7.23845 -0.707439 -7913 4 1.19104 14.6475 11.7231 10.7485 2.93157 -30.114 -7914 6 35.0001 14.2727 28.079 63.2852 10.3217 34.449 -7915 4 34.8812 14.1453 29.0533 -4.19424 -2.10072 -23.3494 -7916 4 34.1798 14.2655 27.6589 -51.5469 -5.32036 -14.2309 -7917 6 54.7125 6.11605 21.8555 -14.0361 -8.25377 2.86163 -7918 4 53.7845 6.02557 22.1597 12.8111 1.82594 -4.22103 -7919 4 0.03027 6.89073 22.319 4.64766 10.0402 5.34703 -7920 6 31.7713 16.925 27.3783 -6.86907 -7.88471 17.2493 -7921 4 30.8352 17.1376 27.29 -7.38275 1.84485 -8.02972 -7922 4 32.1916 17.1776 26.567 8.49209 11.7792 -21.4891 -7923 6 14.465 28.0197 11.093 -4.59026 -39.5121 13.6529 -7924 4 14.1257 28.8224 11.4501 -8.46011 24.0779 0.0563038 -7925 4 14.7692 28.1802 10.1981 4.52198 5.50754 -5.24146 -7926 6 35.6475 19.4845 18.3155 9.57103 -1.809 -3.39748 -7927 4 36.1727 19.3545 19.1113 -4.74674 6.51425 2.74698 -7928 4 35.0476 18.7267 18.3208 -0.78661 10.9943 -3.1182 -7929 6 0.909574 12.7326 15.4512 -4.00403 -44.3255 -0.361194 -7930 4 0.713888 11.7498 15.2844 2.79491 38.2978 9.54583 -7931 4 1.42535 12.7402 16.2831 -6.10996 -1.10113 -5.97882 -7932 6 52.7151 14.8297 20.9852 -8.18072 -78.4028 12.8764 -7933 4 52.2089 13.9625 20.7908 19.9141 35.1606 18.4317 -7934 4 52.3599 15.4219 20.3591 -8.09633 28.1752 -16.3986 -7935 6 7.5074 6.79303 13.6094 20.1749 -33.1825 -2.20484 -7936 4 7.51894 7.72815 13.8132 13.5555 7.5777 -3.02343 -7937 4 8.44355 6.42469 13.5879 -32.5694 21.0012 0.325521 -7938 6 12.8707 29.146 30.9458 -23.5578 15.3335 -40.981 -7939 4 12.9428 28.445 30.3111 -4.06483 -0.044806 -18.3112 -7940 4 13.2276 28.7127 31.6654 25.7046 -17.9249 62.7325 -7941 6 8.91318 29.991 35.6703 -0.0610651 3.14803 31.5119 -7942 4 8.887 30.0597 36.6571 13.1627 -14.4278 -23.4692 -7943 4 8.81345 30.9051 35.4106 0.983205 7.41015 -17.1111 -7944 6 29.2436 7.20633 5.57892 -54.0378 33.243 -15.4453 -7945 4 29.9077 6.6209 5.82325 37.3203 -38.0996 12.3519 -7946 4 28.4255 6.92245 6.05186 24.5111 10.6259 -6.90283 -7947 6 25.8948 9.2579 3.86177 -16.7921 -19.1399 -16.9328 -7948 4 26.6486 8.78935 3.46547 3.6066 2.83982 9.7025 -7949 4 25.146 8.75694 3.47524 9.6908 8.1243 10.3781 -7950 6 46.1591 19.5353 23.8511 81.1089 -3.44953 5.31324 -7951 4 47.0572 19.4192 24.3423 -46.5837 0.334518 -9.80273 -7952 4 46.5432 19.8542 23.0066 -21.4105 0.836057 1.37554 -7953 6 18.5926 35.3225 28.784 52.2521 -24.0621 1.05868 -7954 4 18.6271 36.1437 28.292 -9.91963 10.3291 -8.20284 -7955 4 19.5499 34.9756 28.7398 -42.866 14.0686 4.10052 -7956 6 27.9863 22.6413 32.202 21.6529 -11.7193 -18.2399 -7957 4 28.0891 22.9783 31.3009 1.03266 3.02954 6.56078 -7958 4 27.1414 22.9613 32.5068 -4.28354 -0.549074 4.96673 -7959 6 25.9903 18.4326 22.6797 -22.9747 -15.6034 11.3844 -7960 4 26.7869 18.8273 22.3692 24.9379 13.7229 -5.91644 -7961 4 25.7208 18.921 23.4832 11.724 -6.94511 -8.75168 -7962 6 31.1697 23.092 29.1693 -11.9745 -15.1316 21.2053 -7963 4 31.2077 22.141 28.9533 -3.34012 7.58841 -3.35467 -7964 4 31.7416 23.575 28.5808 9.8436 3.86516 -11.5721 -7965 6 36.6303 4.93142 0.48008 48.3 12.3871 -22.3067 -7966 4 36.6637 5.82298 0.895967 -3.77214 -15.5899 -6.86281 -7967 4 37.4556 4.91994 41.7793 -42.6939 0.501904 23.801 -7968 6 36.4828 20.995 10.0445 1.4409 16.9025 7.88029 -7969 4 36.442 20.1354 9.60774 -3.67605 2.90774 1.0232 -7970 4 35.8889 20.9899 10.8082 0.675338 -5.55749 -3.21659 -7971 6 50.6068 25.1826 18.3885 -34.0155 8.99756 4.28297 -7972 4 49.9165 24.7513 17.8483 3.12051 4.84127 10.9758 -7973 4 51.4426 24.9479 18.0312 23.0155 -7.64449 -5.94589 -7974 6 50.1857 39.6546 12.4249 -35.8487 -4.75972 18.1961 -7975 4 49.7435 38.8097 12.6589 9.38526 12.3917 -5.89531 -7976 4 51.0761 39.4561 12.2056 25.3285 -5.23538 -8.69122 -7977 6 30.5392 12.4112 4.81308 -24.6918 -8.37115 23.8709 -7978 4 30.0105 11.5821 4.90198 12.5687 16.0288 7.14 -7979 4 30.9611 12.2897 3.99028 20.9425 -4.88336 -30.4106 -7980 6 28.9507 15.4785 21.8764 2.88494 -37.77 16.9414 -7981 4 29.2026 14.5932 22.3105 -13.0637 39.016 -13.1967 -7982 4 28.2142 15.8194 22.4189 7.40001 -5.36107 -10.8423 -7983 6 14.0621 9.56364 16.9937 6.86557 -12.9325 3.68967 -7984 4 14.7638 8.91135 17.1437 -0.397896 3.39204 -3.97785 -7985 4 14.5001 10.412 17.0773 -1.84745 7.98018 -3.95086 -7986 6 4.48418 30.1793 11.8502 16.4679 -16.8356 33.0547 -7987 4 4.88144 29.8061 12.6848 -7.18701 8.62616 -23.9784 -7988 4 3.54784 30.2411 12.0492 -7.30801 4.11375 -9.31782 -7989 6 40.8925 8.06286 23.6531 -5.33465 -0.617655 -7.49645 -7990 4 40.8929 8.28602 22.6923 5.67883 -10.477 13.1878 -7991 4 40.7177 7.10184 23.7416 4.86142 9.55736 -10.8624 -7992 6 53.7474 35.0502 16.7091 9.64852 13.8526 -34.5004 -7993 4 53.4511 35.8404 17.1588 -1.68768 2.98716 11.3576 -7994 4 54.0332 35.3898 15.821 -5.01984 -16.258 24.672 -7995 6 53.7089 10.1864 20.3635 2.29909 -3.91508 11.8946 -7996 4 53.865 9.95358 19.435 -6.30341 10.2468 0.803923 -7997 4 53.074 10.9174 20.4153 4.1525 1.61451 -13.3956 -7998 6 4.58325 27.0727 7.79253 38.2121 26.3993 -10.0836 -7999 4 5.27724 26.393 7.80253 -10.2172 -9.80276 1.23658 -8000 4 3.71677 26.7514 7.92113 -24.69 -25.9094 6.50141 -8001 6 50.5074 22.5408 22.1421 -8.69376 -16.3879 19.9073 -8002 4 50.2488 23.2402 22.7623 5.11604 2.17524 -13.9015 -8003 4 50.7961 22.8564 21.2903 3.5618 14.8025 -7.32432 -8004 6 7.04732 27.2027 21.6256 -40.8926 -21.8944 23.9514 -8005 4 6.7035 26.7027 22.422 28.3929 12.8045 -18.4773 -8006 4 6.19014 27.4064 21.2095 22.0893 5.82121 -6.88916 -8007 6 23.8331 35.0488 16.5891 16.32 14.4309 46.4508 -8008 4 24.6955 34.7392 16.9507 -15.4311 10.68 -10.0146 -8009 4 23.6772 34.608 15.7848 -0.180345 -20.5093 -35.2233 -8010 6 5.99568 23.9111 3.91414 -16.1284 -13.3557 2.33299 -8011 4 5.47632 24.0272 3.08057 3.14343 -7.41418 20.837 -8012 4 5.41258 23.5631 4.6401 5.53308 9.77645 -18.8553 -8013 6 38.7285 25.0725 19.1284 6.5843 12.292 11.4002 -8014 4 38.8305 24.3279 18.5317 -0.433768 -14.0645 -4.65001 -8015 4 38.9527 24.8378 20.0476 4.74577 -1.1864 -10.184 -8016 6 12.9754 18.2903 10.6176 0.588158 -4.74371 -11.7219 -8017 4 12.1189 18.2831 10.1754 -4.50324 1.27903 -1.36841 -8018 4 12.8026 18.5801 11.5112 2.24696 5.46905 14.7352 -8019 6 38.0467 41.2366 21.1082 -14.4892 -16.6352 -5.66336 -8020 4 37.1721 40.8226 21.1941 10.2151 -2.13153 3.70269 -8021 4 37.8745 0.133442 20.6393 0.730193 23.6843 -6.95691 -8022 6 6.9767 22.8602 17.8447 -15.6268 -18.8158 0.81989 -8023 4 7.5707 23.5707 17.6602 21.732 18.7089 -7.75629 -8024 4 7.31556 22.0497 17.428 2.05587 4.83625 4.35773 -8025 6 24.1095 19.3932 12.3316 12.1602 -2.11517 -13.1018 -8026 4 23.8745 19.734 13.1953 2.64822 12.0925 0.881714 -8027 4 23.8476 18.4865 12.3899 -10.6841 -23.2361 -5.46211 -8028 6 44.2232 28.4408 4.82746 -1.7669 2.66578 -25.5607 -8029 4 44.2803 28.1144 3.91045 1.22274 -3.80694 10.7546 -8030 4 44.1446 29.3994 4.68927 4.81937 -0.158515 8.55 -8031 6 23.3113 8.29915 21.4219 -9.51684 27.1403 7.66167 -8032 4 22.936 9.22921 21.4746 15.7805 -27.4461 5.90598 -8033 4 23.1012 8.0569 20.5135 3.89809 -6.65443 -0.402871 -8034 6 14.3464 2.18773 18.5362 -23.516 16.4481 4.67993 -8035 4 14.2678 1.24418 18.6898 10.1474 -10.2606 4.48578 -8036 4 15.2445 2.40605 18.3047 18.9771 -8.71598 -6.68368 -8037 6 28.0424 31.9381 34.1184 1.44373 -10.4149 10.0158 -8038 4 28.467 32.321 34.8914 3.92062 5.65333 3.09761 -8039 4 27.2701 32.5111 33.9835 5.51879 -6.95928 -12.9635 -8040 6 53.345 24.6925 18.2818 -10.4918 -25.9433 -31.7967 -8041 4 53.4866 24.6975 17.3285 -0.882305 -10.6531 -2.1422 -8042 4 53.7306 25.5021 18.5264 15.118 39.739 24.3772 -8043 6 36.8049 28.4285 22.9464 16.1639 5.31016 -1.79263 -8044 4 36.683 28.9472 23.7552 -13.3671 -7.69746 -0.238436 -8045 4 36.1639 27.7179 22.9267 -11.0056 -9.60672 10.1241 -8046 6 21.894 30.586 27.4834 -30.837 -7.47848 12.2714 -8047 4 22.1658 31.0121 28.3029 9.93408 7.2142 -4.82479 -8048 4 22.5499 30.6966 26.8178 23.3081 1.01511 -13.2982 -8049 6 10.2866 3.2829 27.2371 9.19947 -3.548 -7.92128 -8050 4 10.1566 2.73648 28.0281 -11.5907 7.20828 -5.58516 -8051 4 9.50383 3.79492 26.9844 -8.05462 -4.00143 11.7964 -8052 6 37.7145 25.01 29.7057 15.6828 -51.4836 -24.4954 -8053 4 38.34 24.5625 29.0621 -16.831 21.3675 19.2093 -8054 4 37.2613 24.2159 30.07 -2.41186 22.6264 5.87672 -8055 6 9.13271 24.4444 14.4751 26.0421 8.18538 46.692 -8056 4 9.10912 24.9781 13.7161 -5.31341 21.9098 -32.4591 -8057 4 8.68548 23.6494 14.2981 -19.3974 -37.2941 -14.6224 -8058 6 52.771 31.4727 7.38558 20.6973 -2.13415 1.08713 -8059 4 52.3061 32.183 6.93204 -2.34942 2.78723 -4.55897 -8060 4 52.1263 30.9997 7.89938 -16.8139 -9.70652 3.3966 -8061 6 21.3286 5.45224 36.4983 22.333 -40.4406 3.83692 -8062 4 20.7026 5.40277 37.2139 -7.55906 11.9598 8.05023 -8063 4 21.8475 4.61683 36.6516 -9.65069 29.8227 -15.0031 -8064 6 25.1743 37.2092 4.31919 7.23092 6.80805 -6.24923 -8065 4 25.4754 36.7175 3.5165 -8.68629 0.834167 19.7743 -8066 4 24.8491 36.6197 5.01948 2.53349 -5.19005 -7.77823 -8067 6 34.0165 17.4759 18.2358 -58.4306 -31.0723 45.6386 -8068 4 34.1944 16.9598 19.0779 8.50138 15.1756 -22.5601 -8069 4 33.0528 17.7413 18.4058 39.5305 3.9888 -12.396 -8070 6 37.9578 37.5059 25.2944 -35.6234 -15.4362 -10.7836 -8071 4 36.9622 37.6721 25.197 38.0574 -5.35834 -1.14338 -8072 4 38.1643 36.7565 24.689 -7.79603 13.8086 8.25116 -8073 6 5.07735 4.86484 15.8417 42.9381 3.72816 7.10952 -8074 4 5.88838 4.293 15.9163 -33.8081 0.492332 -6.16483 -8075 4 5.50277 5.71956 15.9997 -16.006 -0.473971 1.61617 -8076 6 14.1507 7.19336 7.76886 38.052 -10.4208 -22.4486 -8077 4 13.5129 7.55624 8.34295 -29.9694 15.266 25.1048 -8078 4 13.7195 6.96448 6.9333 -0.98027 3.69224 9.82406 -8079 6 24.98 10.8641 38.0829 22.9212 14.7137 56.6455 -8080 4 25.3157 11.7906 38.09 -5.76353 -21.6486 -14.5596 -8081 4 24.5861 10.6473 37.2742 -21.4949 -6.61803 -48.2716 -8082 6 35.683 7.97762 22.8121 -8.7657 -2.24292 -6.28447 -8083 4 36.2591 8.71308 23.0369 7.49089 3.45465 4.10549 -8084 4 35.4159 8.13228 21.894 -1.16553 2.61323 2.89561 -8085 6 24.8067 29.1485 22.4175 -2.13284 -11.1741 5.39142 -8086 4 24.8847 28.3567 22.9764 5.78872 7.02228 0.265808 -8087 4 23.868 29.1687 22.2304 -8.38579 3.51829 -7.32943 -8088 6 38.496 31.6463 38.4547 5.18571 -7.52333 -11.192 -8089 4 38.5561 32.3892 37.8222 0.442926 -5.96945 11.3455 -8090 4 38.4779 31.9675 39.3579 -6.04594 15.0172 8.52038 -8091 6 7.23911 33.2316 15.4021 21.919 9.41665 12.382 -8092 4 8.12833 33.2899 15.8377 -30.0201 5.59214 -9.80336 -8093 4 7.41373 32.5516 14.7298 -12.8129 5.82399 11.4308 -8094 6 43.353 23.6104 1.44592 7.44142 11.305 12.851 -8095 4 43.1845 24.4377 0.974361 -3.6145 -11.1369 -5.61195 -8096 4 44.1543 23.8467 1.95013 -11.1925 -12.9992 -13.6036 -8097 6 3.53991 32.9016 14.8697 -2.39625 2.76445 6.29056 -8098 4 3.69073 33.2429 13.9877 -3.53656 0.018747 -12.9915 -8099 4 3.78624 33.6349 15.4383 2.83762 5.11564 5.16825 -8100 6 25.3096 21.77 8.26163 -6.66296 0.990367 -4.9072 -8101 4 26.025 21.1206 8.24337 -4.14835 5.1806 10.2199 -8102 4 24.7855 21.68 9.08833 13.2195 -2.77387 -11.0894 -8103 6 43.8224 15.3683 17.7688 -17.5044 -13.9077 -11.4765 -8104 4 43.5422 15.0425 16.8907 -4.65964 7.2866 4.53357 -8105 4 44.7684 15.2434 17.7192 12.2011 1.97977 1.51727 -8106 6 15.7838 16.2525 16.6573 54.0838 12.7989 52.3812 -8107 4 16.4697 16.8261 16.2793 -6.54184 -0.771336 -3.5329 -8108 4 15.1467 16.1661 16.0105 -48.6612 -2.23154 -48.9531 -8109 6 31.9022 12.8519 11.5241 2.75902 49.2592 5.12049 -8110 4 32.4395 13.2725 12.2474 -7.6131 -20.2803 -12.0836 -8111 4 31.5562 13.6461 11.0457 0.0384164 -26.7823 6.27126 -8112 6 18.2248 5.33623 10.1812 -15.488 18.8418 -23.6702 -8113 4 17.7687 5.75894 9.42369 15.7694 -11.8332 4.62439 -8114 4 17.5271 5.29555 10.8288 -1.36455 -9.23689 12.3446 -8115 6 23.0917 39.0779 10.9282 -11.4905 7.21092 -0.352408 -8116 4 23.963 38.6888 10.8472 1.7552 7.95734 1.65941 -8117 4 23.1114 39.9529 10.5005 0.666922 -10.0515 1.633 -8118 6 46.8677 33.7562 8.76248 1.03354 -2.05441 8.38343 -8119 4 46.5037 34.5328 8.27588 2.5022 -8.853 20.9954 -8120 4 47.1475 33.9422 9.6931 -6.44786 13.1686 -22.3696 -8121 6 31.243 39.9317 20.2224 2.33635 -7.70313 -8.05101 -8122 4 30.8704 39.2996 19.5871 0.699046 7.37293 6.91414 -8123 4 32.2017 39.8574 20.0757 -3.27099 6.09826 0.0696837 -8124 6 15.889 33.0919 19.7864 33.8788 -7.40125 -13.3883 -8125 4 16.1628 33.8221 19.1895 -10.4151 -15.5823 0.760964 -8126 4 16.5176 32.3427 19.5839 -16.9866 18.4919 10.6578 -8127 6 32.5555 39.9164 2.66523 30.0039 -10.6491 -2.95451 -8128 4 33.3508 39.5896 3.12591 -10.8726 3.49711 -8.16538 -8129 4 32.1027 40.3655 3.36837 -16.5932 8.39248 6.84073 -8130 6 50.6959 12.1983 3.90519 17.0412 -18.9771 -24.2847 -8131 4 51.4658 12.4814 3.40053 -2.43524 -2.94964 -4.56419 -8132 4 50.632 12.8314 4.58319 -9.04718 30.5099 32.8795 -8133 6 44.7022 2.76366 12.1205 -8.84849 12.6495 8.41904 -8134 4 44.8494 1.8734 11.8267 15.0216 -15.1797 -4.64519 -8135 4 44.7278 2.73137 13.1008 3.87902 2.35132 -20.2006 -8136 6 11.5141 11.9335 31.6448 -3.41939 3.48047 19.9552 -8137 4 11.2577 12.7405 32.1375 2.53248 -5.05318 0.0588515 -8138 4 11.4496 11.2091 32.2982 6.40928 8.91696 -7.15415 -8139 6 4.75269 10.0418 10.4949 -1.19321 15.9867 3.21309 -8140 4 5.0001 10.2283 11.4058 3.15466 -0.54389 -0.234941 -8141 4 4.46559 10.9018 10.1184 3.18705 -14.0527 1.96128 -8142 6 17.0994 25.0099 20.58 37.5195 36.994 -31.4742 -8143 4 16.2483 24.8536 20.9144 -42.3557 -15.7488 8.6923 -8144 4 16.9647 25.6792 19.8535 4.26961 -24.361 15.5384 -8145 6 48.1092 4.75471 14.8037 19.9531 12.9172 -19.4869 -8146 4 47.21 5.0173 14.8371 -33.3483 -4.43172 15.4156 -8147 4 48.388 5.38041 14.11 12.4129 -13.382 8.75366 -8148 6 18.8523 3.11742 3.41631 -21.2483 -3.07087 -4.7476 -8149 4 18.4665 2.24821 3.59937 1.50537 0.955968 2.27262 -8150 4 19.7704 2.98892 3.60058 26.8928 -3.50499 2.30699 -8151 6 35.4247 26.4577 29.0527 -22.8013 -8.66021 5.68805 -8152 4 35.5248 27.2067 28.475 -2.85698 13.778 -9.76065 -8153 4 36.2768 26.0489 29.0602 21.3259 -10.4415 3.203 -8154 6 32.3896 31.2185 12.8503 57.1958 12.7231 -6.23232 -8155 4 31.5925 31.2509 13.3022 -48.7441 2.01486 27.8379 -8156 4 32.2029 30.8426 12.0127 -5.8383 -14.614 -31.3947 -8157 6 33.0076 28.3366 37.5983 -27.3824 -5.67666 30.0102 -8158 4 32.1052 27.9852 37.8568 28.4022 2.55731 -9.07316 -8159 4 33.3988 28.5694 38.4733 -3.969 -4.9759 -22.0899 -8160 6 45.5072 24.7908 10.3169 -45.8214 60.3209 -7.47747 -8161 4 44.9002 25.317 9.70444 28.5781 -13.9385 29.3176 -8162 4 45.5876 23.9971 9.85482 14.9117 -49.3191 -19.3714 -8163 6 14.779 31.7044 3.16918 -45.5594 -6.97168 29.5477 -8164 4 14.0337 32.2859 2.90387 21.9125 -3.3602 -3.07131 -8165 4 14.4311 31.26 3.996 20.2164 14.1486 -26.6391 -8166 6 31.9242 7.68885 4.30286 23.54 -20.9123 31.4536 -8167 4 31.4705 6.84633 4.17995 2.0164 -2.82895 4.59018 -8168 4 31.5931 8.24323 3.64247 -18.259 33.7262 -37.7068 -8169 6 42.5699 17.3136 32.1968 24.1944 7.3606 3.32713 -8170 4 41.6254 17.2329 32.2603 -19.9776 4.79877 -7.53323 -8171 4 42.7917 18.2007 31.8224 -10.4585 -19.5065 0.0265862 -8172 6 13.8071 23.1746 23.5515 16.4347 -15.6283 -2.15259 -8173 4 13.5183 23.7639 24.245 0.233797 9.11225 10.6616 -8174 4 14.6093 22.7029 23.9066 -20.7684 16.5326 -5.05411 -8175 6 10.7126 7.09833 3.97095 14.1471 -33.6721 -68.9477 -8176 4 10.4245 6.93934 4.82914 -14.4566 -0.97954 55.1879 -8177 4 10.4869 6.2311 3.50145 10.3151 35.4271 10.8748 -8178 6 28.7967 8.6797 17.9015 -30.1103 -2.72244 -33.0478 -8179 4 29.5795 8.35746 17.4579 9.90558 -6.78874 -8.85398 -8180 4 28.1705 8.90161 17.1378 19.1156 -3.64084 26.8114 -8181 6 19.4515 29.3423 26.6295 -39.4767 12.5835 42.7579 -8182 4 19.0038 29.6555 27.482 17.5864 -10.0531 -35.2193 -8183 4 20.2946 29.7741 26.6551 17.8114 4.03003 1.9258 -8184 6 40.6571 40.9865 14.5722 30.7749 0.116883 17.4953 -8185 4 40.9453 41.7159 14.038 -4.90719 13.3855 -18.4876 -8186 4 41.4974 40.7167 14.9881 -11.2006 -4.47055 2.16552 -8187 6 46.2595 14.0857 31.7293 11.6035 -9.35965 4.24636 -8188 4 46.4659 13.1386 31.6985 -1.25294 5.8657 1.71226 -8189 4 45.5092 14.1916 31.1613 -13.5258 4.10617 -10.238 -8190 6 36.7111 36.3198 8.38634 20.5175 24.5507 44.7988 -8191 4 36.5848 37.248 8.66174 -25.6048 -20.3538 -28.8485 -8192 4 37.4262 36.1922 9.03978 -4.76011 -28.7723 -18.9481 -8193 6 30.7791 32.4382 38.0814 8.60258 1.74334 21.9396 -8194 4 31.3949 31.9394 37.5795 9.21482 -20.9838 -26.5205 -8195 4 31.4122 32.9586 38.5821 -11.3785 16.1645 3.6603 -8196 6 47.8794 8.8384 10.1746 26.299 41.1069 27.7005 -8197 4 47.2075 9.11907 9.56312 -13.0744 -2.84885 -16.672 -8198 4 48.1152 7.93695 10.1106 -1.40956 -33.8723 -12.987 -8199 6 24.4191 17.0005 30.9872 -11.3759 2.04439 -13.9008 -8200 4 23.6647 16.9339 30.3566 16.9629 0.0568796 9.7226 -8201 4 24.0218 17.1528 31.8579 2.94571 -1.21426 -7.57694 -8202 6 40.5018 5.09847 4.47991 -26.6992 -20.3188 -5.14046 -8203 4 41.28 5.65048 4.47318 14.3705 11.228 -11.5737 -8204 4 40.0798 5.05838 3.58104 19.0568 4.03597 15.916 -8205 6 52.5742 28.0973 6.9077 -25.4379 -29.0344 16.6943 -8206 4 52.3933 28.6001 6.11132 1.2128 1.19853 -1.81518 -8207 4 51.7383 27.5823 7.10916 28.4347 22.908 -9.38917 -8208 6 36.064 32.3866 23.6124 7.53581 -25.1682 -6.10704 -8209 4 36.4508 32.2046 22.7426 1.48893 5.77393 9.47334 -8210 4 35.7934 33.2936 23.5958 -9.41601 17.7382 0.925908 -8211 6 23.6488 31.8764 22.7665 2.85736 4.06253 -9.33391 -8212 4 23.7634 32.5358 22.0878 -9.04528 15.3932 -0.43099 -8213 4 24.3599 31.3007 22.5126 8.23075 -21.5035 13.0322 -8214 6 0.735457 24.4657 41.7131 -9.37188 -1.3071 -20.2528 -8215 4 1.20497 24.8068 40.9273 -3.735 -3.01915 11.177 -8216 4 54.8235 24.2347 41.4089 15.688 5.53844 3.35783 -8217 6 15.9771 8.98022 19.8191 22.6241 -28.8974 20.594 -8218 4 15.5109 8.26292 19.4118 -7.13343 -10.7615 -13.7959 -8219 4 15.6388 9.77471 19.4696 -19.2292 39.8019 -15.8774 -8220 6 33.1716 12.5629 20.0326 13.9441 -12.6476 -4.49459 -8221 4 32.9044 11.6183 19.8429 16.5289 30.3248 6.35834 -8222 4 34.162 12.7185 19.975 -34.5589 -12.2038 -12.3621 -8223 6 7.03971 24.945 26.3683 -0.33354 -9.69316 23.9049 -8224 4 6.80945 24.3756 27.1101 -9.22275 -9.46444 -2.85995 -8225 4 7.84656 25.3251 26.6963 17.391 9.90995 -3.06061 -8226 6 44.4739 22.5508 36.9255 -16.7075 -6.88118 10.4755 -8227 4 43.5027 22.4108 36.9334 15.1456 1.07948 9.67769 -8228 4 44.6732 22.7799 36.0336 3.04889 5.98288 -21.3947 -8229 6 39.2775 23.7142 25.1185 -44.4168 -97.0378 5.9092 -8230 4 39.6033 24.5307 24.937 33.9242 88.3913 -14.6991 -8231 4 38.7559 23.4597 24.3323 8.03463 3.9453 13.1815 -8232 6 20.3756 2.20712 36.9897 -7.56257 -5.27652 1.95266 -8233 4 20.2168 1.45659 37.5665 4.06747 -3.41627 8.94019 -8234 4 20.2802 1.85339 36.1124 5.28277 1.38 -10.8685 -8235 6 22.8571 19.5527 3.6659 6.2145 7.79245 45.4341 -8236 4 22.8782 19.7834 4.64919 -10.5004 -5.13291 -37.3231 -8237 4 23.7426 19.8021 3.38476 9.02488 -3.84737 -6.15569 -8238 6 31.6989 12.5719 34.5929 20.3571 12.3337 69.8717 -8239 4 31.0774 13.2339 35.0297 17.9304 -15.3013 -22.977 -8240 4 32.3378 12.3324 35.3667 -30.4994 7.85147 -45.3393 -8241 6 12.9846 10.2214 25.1019 -30.6317 10.0697 -32.3453 -8242 4 13.6677 9.95937 25.6652 38.8731 -4.05338 37.0168 -8243 4 12.5116 9.4018 25.0264 -11.673 -9.01961 -8.06086 -8244 6 27.2702 0.587979 13.2088 -29.2359 -8.68669 8.17042 -8245 4 27.7024 41.6312 13.2942 -2.56798 3.03598 -7.56301 -8246 4 26.2795 0.464606 13.259 26.6373 -0.778522 -5.81594 -8247 6 5.6575 24.9337 13.9905 13.1991 2.90197 -9.87868 -8248 4 4.70598 24.9553 13.883 -5.9976 0.782062 8.57209 -8249 4 5.90972 25.4072 14.7914 -9.20077 -1.59682 1.38283 -8250 6 22.9799 17.9518 0.527007 -12.0607 -30.0717 13.8125 -8251 4 22.428 18.6392 0.176667 -3.67819 14.6501 -9.17369 -8252 4 22.2816 17.3415 0.914453 31.709 16.1034 -10.9012 -8253 6 33.0985 25.4181 5.46205 -15.7978 -31.0624 1.20161 -8254 4 33.3789 26.3039 5.55078 15.9502 30.9866 -6.27287 -8255 4 32.9645 25.2082 4.52957 3.04969 3.7853 3.27689 -8256 6 8.52872 7.94688 17.4833 18.4257 15.9711 -24.7978 -8257 4 9.39098 8.3855 17.3119 -11.8135 -8.35054 -2.98105 -8258 4 8.4858 7.94817 18.4262 -6.55829 -2.0729 23.5191 -8259 6 26.8237 0.686378 2.88748 4.07 30.2002 2.01549 -8260 4 26.8412 0.391628 3.80568 -3.86709 0.733005 8.35451 -8261 4 26.5975 1.66265 2.91719 8.86873 -29.5911 -1.41132 -8262 6 50.0397 34.7157 15.6267 -11.8175 -1.09292 -1.87233 -8263 4 50.6372 35.2521 15.0721 -14.1207 -5.91477 -4.02646 -8264 4 49.1323 34.6374 15.219 24.748 6.82197 2.94942 -8265 6 46.275 5.00035 11.1282 9.7079 18.7279 -10.06 -8266 4 45.8191 4.20733 11.3912 -11.1099 -14.8598 8.88229 -8267 4 46.9633 4.71614 10.5231 1.70636 -6.51939 -1.67277 -8268 6 33.7833 38.63 35.3851 22.6491 -26.5736 53.3982 -8269 4 34.0604 38.9625 36.3013 -14.2885 -2.00103 -44.5517 -8270 4 33.6201 39.3455 34.786 -2.63152 22.0909 -4.2817 -8271 6 30.8201 25.8435 41.2101 0.522631 -30.718 -12.9218 -8272 4 31.0968 24.9266 41.4082 -1.05643 6.85883 -6.1679 -8273 4 31.1715 26.3436 0.016995 6.66556 20.3816 22.2796 -8274 6 50.2276 0.978128 24.4598 74.6558 22.0158 36.8282 -8275 4 49.5306 0.534407 24.0585 -38.5843 -30.8873 -31.929 -8276 4 51.1134 0.532188 24.3239 -37.6779 9.32343 -0.630533 -8277 6 31.2996 0.720873 19.0302 14.3507 40.5737 -10.6901 -8278 4 30.4605 0.743437 18.5837 -16.9464 -9.10756 -3.3833 -8279 4 31.3343 41.8987 19.5933 -6.31648 -47.867 22.0648 -8280 6 39.0778 29.5479 19.1423 -24.9794 -6.4558 -1.7207 -8281 4 38.1293 29.5816 19.4551 33.1986 -8.08964 -3.40762 -8282 4 39.446 28.6506 19.2986 -6.02354 14.8003 0.990496 -8283 6 21.659 17.5991 25.8953 -11.5386 33.2832 -7.33353 -8284 4 22.0418 18.5204 25.967 -8.02723 -30.5851 6.12101 -8285 4 20.778 17.7492 25.4824 18.7799 -9.30112 4.66445 -8286 6 35.0777 28.803 27.4254 -1.70316 -21.0069 37.4458 -8287 4 35.3301 29.4791 28.0775 3.3924 -2.39002 -8.5847 -8288 4 35.0935 29.2141 26.5843 6.79083 21.8236 -32.9604 -8289 6 30.7137 25.4449 11.6588 -11.4017 25.922 39.321 -8290 4 30.5753 25.9017 12.5616 8.60864 -26.5127 -36.0552 -8291 4 30.5331 26.1452 11.022 4.69716 -0.666916 0.479504 -8292 6 7.33812 15.1344 12.3538 4.68116 -40.544 31.6975 -8293 4 6.75693 14.3594 12.209 2.06777 16.361 -3.14284 -8294 4 7.31295 15.622 11.5607 -9.0052 27.071 -31.8075 -8295 6 16.8334 26.8188 7.04972 -25.5936 3.66279 -30.8653 -8296 4 17.5758 26.708 7.59816 38.4339 -11.2263 23.8467 -8297 4 17.1819 26.9966 6.1597 -5.58153 -2.73835 6.66814 -8298 6 29.5302 33.0784 31.0001 -37.3865 -15.0005 -19.6245 -8299 4 28.6433 32.7554 30.7459 2.04647 15.9344 -4.27919 -8300 4 29.8764 32.2746 31.3613 18.5632 -10.7791 20.7082 -8301 6 14.1048 2.11879 30.9099 -3.69766 -14.7615 43.6071 -8302 4 14.1458 1.95878 31.9138 -8.46722 9.63961 -39.7078 -8303 4 13.6642 1.31591 30.5661 9.09938 8.95306 -0.112961 -8304 6 15.6571 22.2632 2.89617 -37.5764 43.5932 -9.62192 -8305 4 16.4348 21.7941 3.05118 39.5293 -34.0009 4.7875 -8306 4 15.0286 21.6897 2.4522 -3.10464 -12.538 6.06705 -8307 6 23.7259 29.1153 40.9645 17.3396 38.8389 1.6287 -8308 4 23.2818 30.0193 40.9831 11.4767 -32.1544 -0.906545 -8309 4 24.7087 29.2887 40.9216 -25.4222 -7.32646 2.20707 -8310 6 38.1247 14.1642 13.7107 12.8592 31.0763 6.54808 -8311 4 37.6278 13.3808 13.8383 -17.8092 -31.0521 2.1891 -8312 4 38.9029 13.9224 13.2095 7.41852 -3.42228 -8.90759 -8313 6 35.2503 26.5068 15.521 -3.09354 13.3371 19.8917 -8314 4 34.5349 26.5126 14.8818 -0.932758 -4.81772 -4.34805 -8315 4 34.9075 27.0382 16.2823 10.0491 -13.0104 -19.4153 -8316 6 19.0968 34.7379 16.486 5.71756 23.995 22.7437 -8317 4 19.4075 35.6523 16.3704 4.72819 -11.1284 17.3551 -8318 4 19.0401 34.4508 15.6072 -6.41662 -20.6903 -39.0731 -8319 6 18.1723 29.7514 35.7083 20.6671 12.6318 -10.71 -8320 4 18.3041 30.5743 35.1773 -7.60682 -14.8418 20.474 -8321 4 19.0351 29.5718 36.145 -10.3356 2.9076 -6.19235 -8322 6 54.1213 22.2675 24.9131 12.7342 -33.1199 -26.8219 -8323 4 53.6265 21.7967 24.1967 9.15099 10.4438 12.7736 -8324 4 53.5183 22.8995 25.2476 -23.1208 24.5105 7.38222 -8325 6 30.3446 10.3415 34.0026 7.84994 -0.761596 -9.91104 -8326 4 29.5868 10.4349 34.5739 -14.9697 1.07498 11.7851 -8327 4 30.8511 11.1643 34.0933 -4.52293 -3.62201 3.70872 -8328 6 38.3178 33.8965 18.5989 -35.8058 -11.4104 -3.76591 -8329 4 38.923 33.166 18.7063 19.7544 -4.29321 9.06839 -8330 4 38.8137 34.6503 18.3352 23.7539 21.4454 3.52643 -8331 6 22.4873 14.1653 34.4312 -21.9658 -17.0918 -49.1801 -8332 4 22.5571 13.4626 33.7145 -4.81718 29.7264 22.473 -8333 4 23.0772 13.8965 35.1058 26.7449 -1.29975 22.8703 -8334 6 38.021 0.617904 2.36461 -2.26574 -7.91048 -40.4777 -8335 4 37.6239 1.19646 3.0125 3.99393 1.59858 23.4614 -8336 4 38.7851 0.132723 2.71367 -6.22024 4.30596 13.4956 -8337 6 38.885 41.133 10.292 38.4397 69.693 -20.9517 -8338 4 38.7327 0.223589 10.3334 0.502898 -40.1285 -2.38265 -8339 4 38.1678 40.7662 10.7395 -40.074 -22.1176 34.0334 -8340 6 53.417 21.9266 38.962 18.4876 1.53578 17.2983 -8341 4 52.9974 21.8755 38.1026 3.71535 5.74942 -10.4205 -8342 4 54.37 22.1639 38.7939 -25.8904 -11.793 -3.59034 -8343 6 39.9933 12.7125 36.2959 -18.8272 27.1562 12.2819 -8344 4 39.0734 12.4542 36.2547 -7.90274 -1.75871 9.35878 -8345 4 40.3901 12.0873 35.7283 26.8007 -18.4843 -23.2317 -8346 6 48.44 17.2431 40.5981 -19.9836 6.93831 4.04917 -8347 4 47.6199 17.7956 40.4399 22.5854 -23.5642 7.97707 -8348 4 48.3147 16.8142 41.4747 5.07747 10.2388 -9.33604 -8349 6 32.0284 9.3439 40.0151 10.5149 -12.1651 13.6504 -8350 4 32.8546 9.41316 39.523 -1.99935 -3.17675 -6.39298 -8351 4 31.9706 8.39334 40.2816 -10.0936 21.7982 -4.27543 -8352 6 31.75 22.4929 6.3685 -34.2181 3.54143 23.53 -8353 4 31.3779 21.709 6.82557 12.2201 6.35834 -11.7559 -8354 4 31.3059 23.2194 6.8777 16.0591 -13.7554 -15.3432 -8355 6 51.0144 2.58529 21.579 28.4772 -3.64411 10.4611 -8356 4 51.4343 1.72703 21.8198 -11.0001 9.38403 -4.71992 -8357 4 51.7571 3.20177 21.4507 -11.3685 -6.83795 2.38662 -8358 6 13.6247 22.0465 12.1442 29.0901 0.46256 9.76546 -8359 4 14.4578 22.3795 12.5465 -13.9989 1.27328 -8.95219 -8360 4 12.915 22.6494 12.3833 -3.04453 8.5056 -1.94564 -8361 6 23.6209 24.0381 14.6453 -17.5202 11.834 -36.5316 -8362 4 24.2009 24.4886 15.2598 9.8869 4.60732 -3.70937 -8363 4 23.5497 24.6116 13.8304 3.00595 -20.2815 30.972 -8364 6 9.32136 4.85156 31.2387 8.97842 0.466865 -3.67014 -8365 4 8.41764 4.8259 30.9291 -8.7496 -0.132795 -7.84821 -8366 4 9.23666 5.38964 32.029 2.44443 -3.9247 9.21777 -8367 6 16.6769 26.3146 18.0426 -28.7898 -24.0576 -1.25383 -8368 4 15.7763 26.5978 17.7405 22.2361 3.17889 2.46191 -8369 4 17.2688 27.0532 17.9767 7.52301 23.5471 -7.71583 -8370 6 5.12002 13.5179 11.5454 -28.2867 15.553 -42.5279 -8371 4 4.34318 13.4159 12.0982 -3.89331 -5.54815 13.62 -8372 4 4.69334 13.8537 10.6805 23.3071 -7.58808 40.5266 -8373 6 29.613 23.6535 8.07622 4.06305 -5.39054 -18.0309 -8374 4 29.2087 23.3655 8.89798 -2.48969 6.78204 1.65997 -8375 4 29.356 24.5861 7.97247 8.33853 -10.6544 5.22118 -8376 6 0.809058 7.56442 27.8431 6.90575 4.16885 -14.0934 -8377 4 0.916059 7.33161 28.7668 -1.2645 -7.40385 9.39857 -8378 4 1.47033 8.27499 27.7095 -9.19662 -21.8408 -1.77541 -8379 6 15.4183 9.78145 0.490529 10.0725 -7.13925 0.979932 -8380 4 16.087 9.43012 41.8027 -0.259761 -4.12548 -6.98761 -8381 4 15.4693 9.20893 1.26423 -1.27146 5.63374 6.96511 -8382 6 18.8191 0.059487 34.1187 -25.6574 -0.396319 -31.4644 -8383 4 18.4098 41.5755 33.3103 16.2128 4.97009 18.3796 -8384 4 18.5054 0.975155 34.0945 0.533414 5.37151 1.64989 -8385 6 18.7349 30.7803 29.1665 47.4813 -67.7405 25.7886 -8386 4 19.5534 30.6866 29.7899 -42.3671 12.2249 -32.0712 -8387 4 18.5184 31.6699 29.0545 -8.91834 48.7901 3.3651 -8388 6 48.4474 16.4903 36.136 -4.39653 9.55775 -4.4164 -8389 4 47.5651 16.9082 36.2181 15.0357 -0.381514 0.207393 -8390 4 48.471 16.1274 35.2331 3.08724 1.10756 7.15907 -8391 6 43.7979 0.472205 29.2706 42.555 -4.96452 -15.1149 -8392 4 42.8863 0.267919 29.38 -32.9664 -6.64218 10.9475 -8393 4 44.2792 41.5357 29.3524 -8.26894 11.2804 8.78801 -8394 6 16.7205 13.887 21.3769 2.19577 2.66609 -2.49996 -8395 4 16.2052 14.7022 21.5336 6.85381 -11.1318 0.719729 -8396 4 16.6911 13.4037 22.2072 -6.06459 1.50462 5.19021 -8397 6 17.3883 13.4356 26.2524 27.4966 3.2637 -26.6685 -8398 4 18.1303 13.5822 25.5825 -26.8694 -2.13737 32.6247 -8399 4 17.6394 12.6216 26.7148 -3.51452 -0.718268 0.201186 -8400 6 48.1557 10.2329 23.6958 7.66187 -11.6345 21.9365 -8401 4 48.0869 10.5828 24.5972 -4.20109 -8.3855 -4.21906 -8402 4 47.9242 10.9774 23.1563 3.12678 5.33996 -12.4543 -8403 6 28.2651 17.9126 17.8865 15.704 23.8601 -19.8805 -8404 4 29.0328 18.4581 17.6288 -8.16305 -6.08358 1.86534 -8405 4 28.6272 17.0995 18.2183 0.672722 -20.799 10.0784 -8406 6 54.0866 38.1772 23.6885 15.2416 -7.03948 -9.32302 -8407 4 0.015845 37.9236 23.4759 -13.1891 10.5947 7.1207 -8408 4 53.5403 37.6177 23.1226 -4.14834 -2.69562 5.50015 -8409 6 8.47885 18.3973 11.4073 -18.4373 -13.8141 42.9629 -8410 4 7.63335 18.6519 11.0416 -6.40415 6.02722 -6.48684 -8411 4 9.12927 18.583 10.7796 32.3175 8.52747 -41.6205 -8412 6 45.9451 12.8796 11.0371 -17.0736 -2.86831 -37.3051 -8413 4 46.6905 12.613 10.4807 4.61659 2.073 6.35499 -8414 4 45.2044 12.775 10.3831 8.06265 2.44535 24.075 -8415 6 16.2127 8.79404 14.0297 41.7324 -66.6139 22.361 -8416 4 15.4739 9.28873 13.8367 -45.7772 50.9633 -18.0772 -8417 4 17.0286 9.27652 14.012 9.93977 26.888 -8.08533 -8418 6 42.7214 13.3612 21.3881 16.6788 44.7105 -2.77317 -8419 4 41.8036 13.1589 21.3301 -20.1042 -28.5105 -1.62877 -8420 4 42.6833 14.2978 21.1276 5.52546 -8.26362 1.62797 -8421 6 21.0018 40.4256 16.4674 21.2457 -19.0828 1.73859 -8422 4 20.7372 40.049 17.3276 2.67731 3.65462 -7.46566 -8423 4 21.8606 39.9985 16.1939 -29.0987 10.293 9.55187 -8424 6 45.6337 11.4313 32.9356 51.1157 -40.0447 2.01383 -8425 4 46.3303 10.7696 33.2563 -29.172 28.0234 -20.2541 -8426 4 45.1866 11.676 33.7277 -20.3741 9.53259 21.5498 -8427 6 26.9484 8.87146 24.2965 48.4346 1.85391 18.4292 -8428 4 27.5311 9.68141 24.3337 -29.9021 -15.2605 -8.39328 -8429 4 27.4823 8.26118 24.8676 -16.4416 6.67878 -12.0087 -8430 6 18.977 2.43413 29.3663 0.758316 16.52 -7.40381 -8431 4 18.1944 2.4248 29.9271 -0.767207 -2.12047 7.99903 -8432 4 19.1173 3.36872 29.101 -3.03797 -9.07666 7.57415 -8433 6 8.2454 29.1679 19.723 -8.63488 -12.9151 21.1286 -8434 4 8.14448 28.8871 20.6627 3.14293 7.67545 -21.2948 -8435 4 7.83715 28.464 19.1969 -1.03495 3.62674 2.54809 -8436 6 9.03976 34.3129 18.6533 -7.54593 -6.72093 -3.09965 -8437 4 8.77081 34.2931 19.577 -0.177883 2.97642 -7.59668 -8438 4 9.06659 35.2455 18.4187 6.50563 1.62734 -4.46359 -8439 6 10.1892 11.9266 11.2355 -21.5107 11.0325 -1.739 -8440 4 10.2333 12.874 11.065 17.4692 -2.43612 -1.88546 -8441 4 9.23632 11.7983 11.121 5.09535 -6.80078 4.24402 -8442 6 35.7546 21.6858 36.1669 -23.2352 21.9394 0.834429 -8443 4 35.0265 22.3595 36.1433 18.2091 -18.4066 2.26802 -8444 4 36.3924 22.0173 36.8321 -9.99636 -6.87572 -9.75527 -8445 6 17.0812 12.5048 36.3903 -12.1142 25.6516 12.5185 -8446 4 17.3175 12.8308 37.2812 -0.49448 -9.18651 -10.1264 -8447 4 17.5662 11.7075 36.2155 7.76979 -20.5663 -1.07791 -8448 6 37.1566 13.0227 34.2843 -17.9764 -6.1284 -55.2853 -8449 4 36.5549 12.2662 34.3472 4.68366 1.60167 -17.3784 -8450 4 37.3932 13.1268 35.1567 14.9075 13.7384 64.605 -8451 6 38.9862 29.5501 13.2301 -1.89389 21.6683 -7.70005 -8452 4 38.7944 28.7085 12.8419 -2.19861 -17.9948 -10.7911 -8453 4 38.6501 29.4932 14.1174 1.27468 3.77518 16.782 -8454 6 0.176516 29.3495 29.4845 -12.5141 10.2637 -5.31555 -8455 4 0.737394 28.6151 29.2028 3.82179 3.49987 -8.15609 -8456 4 54.9814 29.9211 28.6995 5.57042 -17.7863 13.6106 -8457 6 15.9458 0.256833 12.7596 -44.0073 4.56069 2.48191 -8458 4 15.316 0.578271 12.0799 19.6091 -0.692249 -3.06606 -8459 4 15.3039 41.7798 13.3939 19.5978 -0.7471 3.56907 -8460 6 3.99127 11.9482 8.78851 -15.4327 -39.7622 32.4444 -8461 4 4.35413 11.6179 7.97869 6.27746 3.41828 -23.4587 -8462 4 3.98972 12.8788 8.75552 1.02746 43.1268 -6.73396 -8463 6 24.041 23.6822 19.9783 33.1595 11.366 0.122861 -8464 4 23.6132 22.8866 19.7159 -20.0299 -17.1205 -2.84168 -8465 4 23.4218 24.2757 20.3917 -9.46777 4.2557 4.80954 -8466 6 4.48057 2.29323 23.9805 -22.9759 10.1361 69.4322 -8467 4 4.73792 2.40802 23.1034 3.49419 10.2026 -52.1527 -8468 4 3.69711 2.85929 24.1902 11.7092 -10.5693 -13.4065 -8469 6 33.0966 27.663 33.8386 -28.073 -12.9468 -7.71443 -8470 4 33.3687 28.5694 33.7309 6.85765 13.8135 -2.76136 -8471 4 33.7449 27.1385 34.2981 13.436 1.78162 12.2729 -8472 6 11.3912 21.7129 6.08719 -17.5666 -2.19741 -2.39462 -8473 4 12.3323 21.6847 6.05692 28.5529 -3.65784 2.285 -8474 4 11.1694 22.1681 5.26899 -4.22105 -2.6604 -2.39966 -8475 6 37.2225 13.5364 23.6261 -18.6729 23.2035 4.88571 -8476 4 37.3138 14.0862 24.4412 -7.0733 -14.7121 -13.3014 -8477 4 37.9734 12.9786 23.5155 30.7338 -8.31921 -1.90296 -8478 6 5.00503 21.0366 33.3647 1.8453 38.5327 -33.3657 -8479 4 4.21257 21.4237 32.9267 15.1329 -13.9269 -2.57683 -8480 4 4.69097 20.5075 34.0602 -12.1996 -25.3348 31.8286 -8481 6 18.1998 37.5792 26.9379 10.6598 2.97497 -14.5277 -8482 4 17.7896 38.4267 27.1371 3.99806 -1.69574 -0.528064 -8483 4 18.8493 37.7746 26.2284 -6.0853 -8.42077 12.5802 -8484 6 19.7447 16.1537 4.6847 3.25094 -1.99961 -5.02271 -8485 4 18.927 15.8729 5.11398 3.02189 5.09699 3.93014 -8486 4 20.4865 15.8366 5.22215 -5.31395 3.35724 3.77112 -8487 6 54.074 32.5125 15.5854 10.3761 -37.3618 -30.9158 -8488 4 54.8842 32.2065 16.0104 -1.29748 4.29224 -6.87141 -8489 4 53.7047 33.0976 16.2003 -18.9781 34.1452 25.1436 -8490 6 31.1314 3.81684 36.7321 -0.834289 -2.49025 -7.10722 -8491 4 31.1103 4.02948 37.6722 -6.54843 -2.60835 4.18586 -8492 4 30.7135 2.95482 36.5673 3.74099 5.55874 7.56308 -8493 6 11.8386 14.3591 5.9475 31.6488 6.08621 47.6135 -8494 4 11.9235 13.4381 5.72501 -3.84758 -8.60837 -9.73648 -8495 4 12.4264 14.4198 6.78937 -30.0453 0.761866 -39.8937 -8496 6 30.4739 33.6971 6.46755 -23.3776 20.1936 16.0158 -8497 4 30.0841 33.0849 7.09297 -6.22519 -2.1618 10.9649 -8498 4 31.0937 33.1726 6.0102 25.8315 -23.5027 -25.5745 -8499 6 12.7945 0.536645 21.6661 -31.9857 18.4102 -14.2222 -8500 4 12.046 0.975194 21.1709 21.6431 -18.6961 6.09473 -8501 4 12.7507 0.998686 22.5059 13.427 -0.157027 11.5383 -8502 6 52.7685 7.22113 26.1957 6.97037 27.5507 21.845 -8503 4 53.4259 7.92282 26.4698 -21.5773 -21.2317 -16.9414 -8504 4 53.0823 6.78628 25.4103 4.46247 -3.68205 -10.7225 -8505 6 39.7279 40.8849 3.7445 22.9677 17.8938 -40.8272 -8506 4 39.3244 40.0392 3.76563 -12.6427 -25.5287 10.0743 -8507 4 39.6614 41.3038 4.58361 -3.65945 6.85452 27.763 -8508 6 20.1085 31.9188 21.9984 -7.05206 -5.67602 7.13377 -8509 4 19.4287 32.0842 22.6964 14.9272 -8.91322 -13.6161 -8510 4 20.3617 32.7769 21.6609 2.64243 15.0084 0.0829653 -8511 6 12.8674 35.0052 4.44359 43.5281 -46.0898 9.1613 -8512 4 12.2643 35.7062 4.40975 -34.4326 42.8527 -2.74399 -8513 4 13.784 35.3443 4.35073 -14.7319 6.47242 -4.65586 -8514 6 24.0589 33.6612 24.8588 9.55704 11.7193 -6.52578 -8515 4 23.7303 32.9012 24.3903 -5.13736 -12.3884 -10.0474 -8516 4 24.8786 33.8838 24.3903 -2.58553 -1.28908 -1.69824 -8517 6 40.1426 40.9082 22.7393 38.5538 -20.8809 37.5387 -8518 4 39.5402 41.0833 22.0513 -32.6743 7.60774 -19.3027 -8519 4 39.6696 40.5795 23.5226 -1.01773 2.4492 -9.99125 -8520 6 15.5532 2.81426 38.4448 -20.0738 34.0709 23.3703 -8521 4 14.8967 3.48174 38.7749 9.17215 -23.4566 -12.8824 -8522 4 16.1607 3.33672 37.9186 19.8661 -0.634992 -1.43825 -8523 6 41.016 9.18565 16.9561 17.4117 -10.7022 -18.9926 -8524 4 41.8597 8.69641 16.8054 -9.41989 12.8418 6.23764 -8525 4 40.6131 8.73354 17.6887 -9.17188 -2.41438 15.2761 -8526 6 43.1923 41.3931 9.58697 -22.3356 -19.1489 -3.62619 -8527 4 42.3612 40.9845 9.24256 14.3618 0.824315 8.65898 -8528 4 43.3433 0.185675 8.9708 1.58778 19.1204 -6.9238 -8529 6 24.903 37.9158 30.7914 -43.8554 -5.41491 21.3724 -8530 4 23.952 37.804 31.173 48.4757 4.96182 -14.1951 -8531 4 24.7905 38.4252 29.9913 -4.69729 3.46822 -12.8277 -8532 6 2.22055 5.32897 16.4318 -0.704957 11.5959 2.51569 -8533 4 1.8086 4.56809 16.8519 3.25773 -6.94195 4.1641 -8534 4 3.17492 5.17974 16.3235 -2.45649 -10.6256 -1.35481 -8535 6 1.39662 14.9371 19.1386 6.71081 10.2639 18.1623 -8536 4 0.558182 14.6006 18.8448 -10.0768 -10.7254 -15.2923 -8537 4 1.25744 14.8844 20.1022 8.06638 5.64899 -3.4629 -8538 6 34.3184 26.5435 23.7018 12.956 38.2174 -10.8067 -8539 4 33.6096 26.6326 23.0506 -6.28704 -5.42218 7.19498 -8540 4 34.253 25.729 24.1673 -8.0715 -30.4977 4.91012 -8541 6 41.932 21.8144 37.5476 -28.1346 24.458 10.6264 -8542 4 41.9653 21.2973 38.3662 8.82952 -0.726087 -9.88338 -8543 4 41.2985 22.5209 37.8344 14.7394 -10.5077 -10.9774 -8544 6 39.4289 37.6722 12.6363 -7.06663 36.6798 -8.56095 -8545 4 38.7214 38.0767 13.1674 9.12422 -13.2372 3.4836 -8546 4 39.8791 38.4903 12.2996 -0.376717 -30.7746 7.3995 -8547 6 30.2308 35.8744 2.88429 56.3256 -5.17531 19.584 -8548 4 29.7395 35.078 2.8871 -14.5394 -27.2578 -4.40621 -8549 4 29.6846 36.541 2.55195 -33.266 39.3858 -14.7027 -8550 6 50.3691 12.2996 11.0379 -10.7742 -32.245 -38.7061 -8551 4 50.5492 13.1381 11.4098 4.20277 26.7051 25.7379 -8552 4 50.0731 11.6929 11.7162 -2.05651 -3.66514 15.0978 -8553 6 38.4203 1.52686 34.6552 6.3891 -23.1477 32.9209 -8554 4 38.2942 1.9363 33.8354 -7.66336 30.6162 -40.7111 -8555 4 38.1079 0.632206 34.5078 -6.35148 -11.0336 -1.97829 -8556 6 23.4679 32.2557 29.2149 -43.4567 -12.6916 53.2324 -8557 4 24.0296 32.8423 28.7424 12.6247 17.2837 -9.6693 -8558 4 23.1232 32.6929 30.0761 24.9901 -11.6617 -44.232 -8559 6 36.561 38.8488 8.89417 42.7368 2.70764 46.8348 -8560 4 35.962 39.5202 8.64255 -29.9788 24.4889 -23.0747 -8561 4 36.8832 39.1244 9.78764 -11.193 -6.37855 -17.8717 -8562 6 35.882 15.8491 32.4345 4.38917 24.4094 -11.8898 -8563 4 36.1253 15.4284 33.2547 4.1797 -3.844 11.2859 -8564 4 36.4849 16.63 32.3181 -12.6028 -21.8682 2.29862 -8565 6 22.2747 21.8257 41.5848 1.63659 45.0851 -0.0273952 -8566 4 22.1351 22.8132 41.5538 -4.13496 -33.3395 13.1468 -8567 4 23.0832 21.7834 41.079 15.3069 -18.439 -3.51535 -8568 6 24.3693 38.6933 37.0124 5.99709 22.8296 -9.01594 -8569 4 25.2224 39.1901 37.0147 -13.2325 -18.2305 -0.0611307 -8570 4 24.4452 38.0141 37.6805 1.8393 -10.9749 7.25289 -8571 6 45.85 22.0674 16.0435 -6.35855 -11.009 -33.5755 -8572 4 46.1693 22.2375 15.1223 -5.70657 5.73574 25.2515 -8573 4 45.3177 21.2496 15.9445 13.424 8.98362 5.88408 -8574 6 34.0938 26.1451 39.6028 29.3502 -8.72422 32.5359 -8575 4 33.1775 26.2044 39.4639 -36.6108 3.5864 -15.8394 -8576 4 34.1454 26.1252 40.583 9.60862 3.8872 -14.9166 -8577 6 7.22316 36.161 23.2803 -75.9344 2.48999 -44.2827 -8578 4 7.2061 37.0658 22.9632 2.60813 8.07149 -4.69042 -8579 4 7.98979 36.1134 23.7455 79.8131 -8.28428 52.3852 -8580 6 29.1469 40.7664 9.14908 25.9603 -62.9641 -41.536 -8581 4 29.104 40.2522 8.28913 -11.1672 35.4313 19.904 -8582 4 29.7179 40.1086 9.59652 -3.22944 23.7461 21.8778 -8583 6 29.3725 11.2348 1.3024 -38.7794 14.8627 17.4065 -8584 4 28.4703 11.3821 0.891273 31.6728 -0.63192 16.6295 -8585 4 29.2803 11.4968 2.26097 5.36173 -12.1272 -32.3877 -8586 6 30.9813 3.70043 14.0775 0.393287 -12.1193 -7.6118 -8587 4 31.3533 2.81844 14.3971 -7.37725 32.1126 -17.4345 -8588 4 30.796 3.71521 13.098 8.52465 -17.2224 25.8707 -8589 6 29.7018 15.2871 38.2765 -11.7342 18.5436 -44.4423 -8590 4 30.2882 15.1814 38.9925 24.3773 -7.28175 32.8118 -8591 4 30.1059 15.9805 37.6877 -12.7379 -16.9908 17.8861 -8592 6 36.618 0.316233 29.1564 -1.13478 17.6011 -18.8673 -8593 4 37.4497 0.805382 29.2328 -0.537074 -5.31334 10.7084 -8594 4 36.0611 0.935156 28.6408 3.38103 -20.3125 11.7491 -8595 6 47.6566 0.117823 23.249 5.11875 5.73062 -10.5794 -8596 4 46.969 0.414744 23.8324 -12.4062 9.53281 16.9836 -8597 4 47.4018 41.1354 23.0496 0.315762 -17.3342 0.264415 -8598 6 7.91605 37.1729 29.9478 9.96828 38.7234 29.3851 -8599 4 7.8238 37.3188 30.9485 4.22886 -13.4646 -46.5453 -8600 4 8.48708 37.9472 29.6677 -24.8232 -29.7333 9.09982 -8601 6 38.925 24.2263 12.6374 28.6028 -18.1679 -25.4959 -8602 4 37.978 24.1747 12.7226 -16.6271 -1.4443 2.40459 -8603 4 39.1586 23.5255 11.9538 -9.24307 26.9603 22.464 -8604 6 21.3053 26.2545 36.7859 14.9917 45.9325 1.16 -8605 4 20.8074 25.7232 36.1994 -14.2562 -21.9874 -17.8757 -8606 4 21.6248 25.6951 37.4625 3.91421 -21.0802 23.8691 -8607 6 28.2258 23.3284 24.9888 19.6442 1.87868 9.60148 -8608 4 28.2493 24.0261 25.6588 -3.93467 -3.60043 -2.01642 -8609 4 29.1002 22.8932 25.0573 -18.3502 1.43704 -4.70914 -8610 6 38.4116 39.5691 14.5896 29.669 -4.24194 25.1928 -8611 4 38.4978 38.8692 15.3261 -6.52385 31.9806 -37.1925 -8612 4 39.2924 40.0897 14.6163 -46.5668 -30.9815 -6.21074 -8613 6 26.0432 5.99751 38.1148 44.5658 1.98351 30.7371 -8614 4 26.452 6.86444 38.1066 -12.5768 15.2327 -11.4433 -8615 4 26.7959 5.51316 38.5398 -27.2991 -6.53191 -16.0548 -8616 6 52.1237 17.2497 22.5073 -27.4301 16.765 14.7973 -8617 4 52.9399 17.665 22.2571 16.5652 5.20466 -11.3284 -8618 4 52.1578 16.3131 22.3678 7.8945 -19.2066 -9.92552 -8619 6 39.5302 30.1999 31.4498 -15.3908 2.56685 75.4769 -8620 4 40.0207 30.5437 32.2484 0.473519 -4.28305 -35.1019 -8621 4 38.713 29.8928 31.926 18.6512 10.8404 -28.7426 -8622 6 19.6503 6.93083 12.7623 15.8343 -24.4908 21.6207 -8623 4 19.8732 6.46228 13.5959 -20.1786 11.9342 -5.76682 -8624 4 20.303 6.55009 12.1776 -0.0209149 2.55819 -14.5973 -8625 6 32.4196 37.4972 40.0987 12.4446 10.4582 -32.0511 -8626 4 32.8186 36.647 40.0719 9.51079 -23.9505 -16.9607 -8627 4 32.1638 37.519 40.9804 -20.9873 13.1856 56.2462 -8628 6 39.7646 0.344956 6.09395 -0.813604 -13.3118 11.6504 -8629 4 40.0929 1.25666 6.05063 3.72657 -6.06719 5.14874 -8630 4 40.1279 41.7919 6.88268 -2.2039 13.7644 -10.8213 -8631 6 28.7754 10.1494 29.1547 6.27663 8.45441 -17.0952 -8632 4 27.8341 10.1814 28.9557 -5.13507 -0.906004 3.81537 -8633 4 28.9096 9.91312 30.0774 -3.02611 -6.60467 -0.689697 -8634 6 28.3509 21.0738 10.6423 20.1214 -0.517468 -23.7169 -8635 4 28.7452 21.9678 10.604 -10.1652 -7.70852 11.001 -8636 4 28.9796 20.5469 10.1008 -17.263 7.26144 14.8814 -8637 6 27.0689 28.6853 20.8654 35.4789 -5.63144 4.47554 -8638 4 27.7442 29.2307 21.3162 -7.53329 -4.62114 -3.00727 -8639 4 26.2324 28.9644 21.1916 -29.8949 8.87289 15.491 -8640 6 39.6884 13.9755 33.4499 14.6401 2.99861 16.5486 -8641 4 40.0373 13.7827 34.3426 -3.85296 -1.51256 -14.2832 -8642 4 38.7457 13.8219 33.5285 -9.87208 -9.87778 -3.27097 -8643 6 25.4679 11.6581 34.316 -5.2989 -28.5582 40.5924 -8644 4 24.7613 11.1605 34.7897 20.9725 -0.466275 -6.59756 -8645 4 25.003 12.0579 33.6214 -16.717 25.3404 -32.2266 -8646 6 27.5101 37.647 21.4263 -39.7295 -31.2682 -35.969 -8647 4 28.2375 37.1633 21.0518 17.2189 -6.02702 -9.55939 -8648 4 27.8241 38.1534 22.1272 30.3423 24.6719 41.8853 -8649 6 30.5838 20.0489 28.6446 73.221 13.9737 -1.42059 -8650 4 31.1441 19.3945 29.1273 -28.9524 12.9537 -8.0961 -8651 4 29.6632 19.9528 28.6439 -45.0502 -19.2043 6.90743 -8652 6 42.3833 1.8554 14.9243 13.367 3.08275 38.4467 -8653 4 41.8907 2.29225 15.634 5.99337 6.74303 1.17955 -8654 4 41.7769 1.84183 14.2131 -17.6385 -4.20156 -32.9301 -8655 6 12.1633 12.5377 19.5325 -23.0245 -19.867 -11.1113 -8656 4 12.9521 12.0237 19.3369 9.43068 0.576721 5.46819 -8657 4 11.4219 11.8853 19.4518 12.4737 16.4774 1.27947 -8658 6 19.216 1.20416 16.3541 12.5689 2.54581 22.2585 -8659 4 19.6937 0.628292 16.9879 -4.91383 6.35485 -14.1526 -8660 4 19.7889 1.98236 16.2594 -2.22189 -4.72354 -7.2618 -8661 6 9.47695 16.1439 27.6873 23.0793 15.684 -40.8775 -8662 4 9.87411 15.9669 26.7875 -8.00596 11.4199 30.6292 -8663 4 9.27844 15.2819 28.0019 -12.6146 -24.0632 14.4486 -8664 6 40.4558 26.1873 24.7848 -5.87099 -8.07067 -10.9608 -8665 4 40.3772 26.6753 25.6381 -3.45584 0.121614 -18.2296 -8666 4 40.075 26.6842 24.0102 9.21367 0.234889 33.0434 -8667 6 47.6742 17.6493 18.027 -37.0889 26.6143 -3.73366 -8668 4 48.2089 18.0323 18.7522 -4.76487 -3.2939 -8.20899 -8669 4 46.8388 18.2201 17.9217 41.9344 -19.3622 12.4897 -8670 6 36.6073 25.2802 4.19388 18.2149 -9.73143 -24.5863 -8671 4 36.604 25.3887 5.14943 -0.00537736 13.7381 3.83127 -8672 4 37.3627 25.7621 3.76942 -18.9403 0.329358 18.8416 -8673 6 39.5721 35.375 29.6682 7.39129 29.0443 4.37935 -8674 4 38.9992 34.6325 29.7528 -8.39079 -18.7886 -5.10368 -8675 4 39.3389 35.9401 30.4162 6.41301 -4.37294 -4.4287 -8676 6 0.402862 14.6299 13.3406 12.3375 -5.37043 -32.3015 -8677 4 54.737 15.2477 13.6388 -5.18731 7.44473 4.40324 -8678 4 0.540834 14.0191 14.0401 1.19186 -14.994 25.3978 -8679 6 12.2127 27.3484 8.43247 -29.2387 -0.771708 1.75024 -8680 4 12.965 26.7512 8.46983 14.5311 5.0326 6.8656 -8681 4 12.3156 28.1607 8.97491 11.1816 -11.3427 -11.9337 -8682 6 36.8986 14.8167 21.1188 31.0797 27.7575 -31.2238 -8683 4 37.0397 14.394 21.9547 2.6333 -10.7207 26.6181 -8684 4 37.7308 15.3371 20.9125 -24.2604 -24.0664 4.77074 -8685 6 20.8464 4.94114 21.1044 31.4042 5.97012 13.2179 -8686 4 20.3644 5.60924 21.5958 -5.50293 4.43366 -4.7096 -8687 4 21.773 5.03668 21.4416 -23.5272 -13.3128 -11.683 -8688 6 36.7544 1.79945 7.61694 -30.3574 47.6061 45.3867 -8689 4 36.327 2.6686 7.87118 16.8784 -26.1974 -29.8241 -8690 4 36.8428 1.50799 8.53455 15.1793 -22.3797 -11.8231 -8691 6 12.2439 31.5023 37.4569 -32.4985 -2.96535 6.06153 -8692 4 12.7586 31.1596 36.7365 10.4364 1.05198 -9.11954 -8693 4 11.3919 31.0227 37.3953 11.2973 8.58078 9.3944 -8694 6 38.9908 41.586 16.881 -5.73716 8.1645 -10.5856 -8695 4 39.3046 41.7073 15.9766 4.30886 -9.33368 3.06156 -8696 4 39.3667 0.405687 17.3669 3.77504 10.3777 9.96207 -8697 6 31.8904 27.2678 22.2602 -2.97266 4.85738 -46.2508 -8698 4 31.2122 26.6002 22.3915 1.88455 0.488126 10.0993 -8699 4 31.7489 27.4981 21.2895 3.71213 -3.79941 38.8104 -8700 6 42.7405 9.18554 25.589 -22.1194 -12.6454 -9.25487 -8701 4 42.0872 8.82691 24.9599 0.650449 1.17306 7.26361 -8702 4 43.4011 9.54846 25.0154 21.3216 10.0262 -4.62936 -8703 6 50.9383 28.1736 25.3544 -13.6318 0.0171378 28.1732 -8704 4 50.4953 27.5553 24.7803 -5.9639 1.72187 -15.2616 -8705 4 50.5272 27.9992 26.2251 14.2447 5.57945 -12.3971 -8706 6 43.1888 19.6578 30.9105 -66.6531 23.7889 25.5358 -8707 4 44.0873 19.829 30.8982 70.1332 9.75906 -5.84371 -8708 4 42.7965 20.4661 31.3425 9.97757 -17.7871 -10.1322 -8709 6 30.6644 14.0457 40.7997 -18.1309 16.7334 54.243 -8710 4 30.3214 14.3504 41.7092 15.0959 -2.90855 -40.5845 -8711 4 30.1739 13.231 40.7145 -1.19418 -16.8866 -12.4659 -8712 6 20.9131 15.4897 23.0235 5.61878 12.7036 12.8066 -8713 4 20.368 16.1905 23.4302 1.66694 -9.32372 -6.67403 -8714 4 21.8218 15.751 23.2692 -7.37195 -9.57776 -6.18749 -8715 6 34.2171 0.764056 35.8253 8.40959 -35.3498 44.9304 -8716 4 34.6567 1.46863 36.3417 -5.08936 -9.30099 -7.81199 -8717 4 34.1194 41.866 36.4755 2.29033 39.9746 -37.3302 -8718 6 38.9162 36.9098 35.9203 10.0793 6.80115 3.36275 -8719 4 39.7784 37.1612 36.3284 -16.0364 -11.2649 -5.21842 -8720 4 38.6132 36.0588 36.2696 9.66804 2.35098 0.533126 -8721 6 45.1336 25.2146 22.7744 -28.8992 3.863 21.2581 -8722 4 44.1561 25.0943 22.7165 17.1243 8.87651 18.653 -8723 4 45.3983 24.7563 22.0047 17.0602 -12.3694 -29.5411 -8724 6 40.597 0.8134 35.9421 3.227 69.6319 -3.88491 -8725 4 40.5509 41.8059 36.0096 -6.03355 -53.2669 -4.53187 -8726 4 39.9427 1.13471 35.2813 10.0151 -17.6297 16.5691 -8727 6 11.0455 28.3465 35.0235 9.7668 1.71998 -0.601403 -8728 4 10.9819 27.7367 35.7737 -0.960779 4.073 1.47136 -8729 4 10.3922 29.0422 35.1677 -11.8786 -4.48184 3.12795 -8730 6 20.2051 13.5934 35.8566 39.7213 -43.4527 45.4399 -8731 4 19.4813 14.0017 35.4777 -48.9883 30.031 -35.164 -8732 4 20.9868 14.0394 35.5673 14.4182 15.1 -18.5178 -8733 6 39.6245 5.13776 1.76997 -0.951619 9.89005 21.073 -8734 4 38.8252 4.77089 1.41386 -14.9185 -6.12031 -3.7056 -8735 4 40.3018 4.93211 1.13633 15.4903 5.30459 -14.5773 -8736 6 30.2698 30.8736 32.4375 -6.71798 15.6036 14.0469 -8737 4 29.6901 31.1438 33.1751 5.76607 1.99955 -8.25679 -8738 4 29.7896 30.1731 32.0039 1.14172 -17.9152 -6.50707 -8739 6 14.5598 11.0088 22.8703 10.5759 -0.53797 13.7125 -8740 4 15.2344 11.6195 23.3114 -32.0235 -23.0075 -11.5695 -8741 4 13.848 10.7777 23.5118 19.1574 10.2796 -1.34673 -8742 6 20.7379 13.9443 3.00881 5.16887 -45.0314 -26.4616 -8743 4 19.9261 13.6658 2.50706 22.866 18.233 23.793 -8744 4 20.5244 14.6819 3.55007 -16.1173 25.3417 12.2311 -8745 6 41.3029 4.28468 12.6203 -8.04128 10.917 21.7417 -8746 4 40.6152 3.63858 12.7642 -6.82471 -4.23516 2.09603 -8747 4 41.6484 4.11485 11.7651 11.719 -9.67534 -28.974 -8748 6 10.8581 24.7328 21.7161 -39.3585 -15.8792 -33.4515 -8749 4 10.0068 24.8598 21.1989 28.1112 14.2693 20.1969 -8750 4 11.1639 23.9123 21.3137 10.3572 -6.50453 7.69671 -8751 6 53.5762 20.8825 34.3773 -29.6915 -0.0415475 -3.94304 -8752 4 54.5085 20.795 34.3185 33.8519 4.29786 -2.30511 -8753 4 53.2552 20.0612 34.7861 8.83511 12.9473 -9.59804 -8754 6 14.8838 4.84499 30.449 -1.65326 0.839716 -13.8987 -8755 4 14.8578 5.00753 29.4799 -4.93385 -7.75961 17.951 -8756 4 14.5437 3.94124 30.5804 2.28716 7.27432 -2.63088 -8757 6 48.9137 37.1159 13.1232 -44.1315 32.6594 -31.0851 -8758 4 47.9268 37.1149 13.1949 24.5681 4.85746 10.1076 -8759 4 49.2024 36.4546 13.7037 17.9017 -30.2536 24.0784 -8760 6 26.8017 19.3068 7.5379 -15.1037 -1.6612 14.6377 -8761 4 27.3245 18.5243 7.34583 -2.01051 -6.65035 -9.19035 -8762 4 27.3053 20.0577 7.2492 18.4232 10.5976 -10.0514 -8763 6 17.631 11.9383 39.0904 -43.3265 13.8677 10.122 -8764 4 18.4941 11.6307 38.9203 38.4816 -13.6738 2.54756 -8765 4 17.5009 12.0978 40.0481 6.31677 -1.58465 -10.4285 -8766 6 49.9233 14.5931 8.61354 5.83785 -36.2985 -8.08798 -8767 4 49.214 13.9285 8.60404 6.89175 6.08198 5.75816 -8768 4 49.5175 15.3796 8.93642 -5.42274 33.9852 6.11405 -8769 6 32.3642 34.9667 31.5078 2.95354 23.7899 20.5819 -8770 4 32.072 34.4222 30.8036 -4.84614 -18.7532 -16.6478 -8771 4 32.4643 35.8463 31.1217 -0.970967 -0.757054 5.3462 -8772 6 11.8286 22.2266 21.3061 -17.2258 -15.6378 -41.9552 -8773 4 12.2171 21.6669 20.5638 -11.8041 19.7065 26.8676 -8774 4 12.3859 22.1258 22.0497 29.6948 -3.02551 21.8379 -8775 6 33.8509 9.96106 13.6416 -14.3875 -24.3714 -53.1057 -8776 4 33.0123 9.50508 13.4028 8.15621 17.9807 22.2309 -8777 4 34.3201 9.78154 12.7883 7.50726 12.1846 28.7729 -8778 6 25.5192 36.3946 1.51103 -10.4602 3.19395 -11.4439 -8779 4 26.0842 36.7323 0.810141 8.62195 6.50952 5.56913 -8780 4 24.6933 36.9065 1.40961 6.72848 -10.059 1.65156 -8781 6 26.2721 10.5411 9.76409 -19.2005 -4.19702 2.88354 -8782 4 25.6096 11.193 9.42675 5.9346 -6.99241 18.1855 -8783 4 25.839 9.94226 10.4354 7.43867 25.8511 -14.7334 -8784 6 25.016 0.794303 40.8954 13.3669 6.17095 4.00755 -8785 4 25.3682 0.342397 40.1084 -6.19889 9.04785 1.09472 -8786 4 25.4075 1.69244 40.9338 -2.19893 -14.7289 -5.24662 -8787 6 46.2434 3.93626 24.8203 6.94819 -22.6825 -8.03363 -8788 4 46.3834 4.04208 23.8743 3.61713 6.01616 -2.12387 -8789 4 46.2394 2.96647 24.9181 -8.37252 7.22853 3.62774 -8790 6 21.5889 13.6037 29.2057 4.95103 8.76674 17.4208 -8791 4 21.6019 14.3052 29.8879 -2.51331 -9.966 -5.68557 -8792 4 21.3126 14.082 28.4253 -2.16645 0.501775 -6.52993 -8793 6 36.7737 38.3803 0.360926 -13.0762 -25.442 -6.6792 -8794 4 36.4499 39.0355 0.978203 -4.80976 12.188 0.88021 -8795 4 36.0266 37.7487 0.22189 15.835 12.8395 4.19355 -8796 6 19.3086 17.6338 24.0617 47.0109 35.6134 -17.5995 -8797 4 18.4263 17.3722 24.1632 -50.3154 -15.1751 2.93786 -8798 4 19.3137 18.3511 23.365 -2.62926 -22.9616 14.087 -8799 6 23.1803 12.6945 3.50697 -12.4047 4.12184 -0.296296 -8800 4 22.2521 12.9621 3.30307 10.5621 -3.58256 -0.535563 -8801 4 23.3663 11.8631 3.0578 -9.23841 -1.30096 -1.53094 -8802 6 37.8891 8.88353 35.4651 -18.9945 -25.3999 -47.3866 -8803 4 38.8166 8.83127 35.1934 2.77199 2.98421 7.2207 -8804 4 37.4068 8.32521 34.752 23.9265 29.6152 37.0755 -8805 6 14.3237 15.1253 36.1844 10.7536 -1.62675 -12.1114 -8806 4 15.0418 15.7291 36.3902 7.37284 -3.65767 0.0646607 -8807 4 13.765 15.154 36.9379 -17.7819 2.51157 18.8211 -8808 6 35.0801 0.941274 33.018 -10.8249 30.7834 33.3167 -8809 4 34.9269 1.883 33.2395 6.71896 -7.58638 -28.1375 -8810 4 34.9733 0.615676 33.9226 0.339269 -19.4543 -11.259 -8811 6 50.9271 0.518298 17.9933 -4.01299 -8.33658 -1.61011 -8812 4 50.7551 1.39133 17.5891 -0.713529 -12.5397 8.99793 -8813 4 50.17 41.8323 17.8017 14.8721 13.6567 -6.57092 -8814 6 26.2328 30.5636 0.934374 -8.95911 39.2037 50.9017 -8815 4 26.9657 31.1139 1.27364 -12.5333 -13.1029 -5.86431 -8816 4 26.5352 30.0815 0.207089 19.4446 -20.9762 -37.1203 -8817 6 18.5681 38.3031 4.5613 16.0408 -0.4472 -12.493 -8818 4 17.6336 38.3732 4.40187 -16.7548 5.85511 1.82222 -8819 4 18.9561 38.7121 3.75593 -0.616515 -6.35836 15.3023 -8820 6 31.1349 5.07457 4.1166 35.5071 -12.4218 -11.0008 -8821 4 31.9258 4.61163 4.53765 -37.2933 13.7034 -13.5003 -8822 4 31.2792 5.02565 3.1391 -9.10044 -1.2591 17.9933 -8823 6 26.4378 21.892 1.49191 0.117022 -23.7737 9.75083 -8824 4 26.3504 22.7277 1.07049 4.38069 30.3527 -12.7348 -8825 4 27.3618 21.6023 1.50897 -0.762137 4.81239 -9.09803 -8826 6 39.2154 11.7026 22.7855 15.1366 1.14561 24.1899 -8827 4 39.8619 11.6546 23.5153 -3.42244 7.72178 -8.31759 -8828 4 38.7922 10.855 22.8508 -11.0077 -10.6036 -7.38167 -8829 6 13.6049 36.3215 30.6697 16.8779 70.0034 -37.8159 -8830 4 13.9417 37.1302 31.1268 -10.116 -30.1168 -5.71441 -8831 4 13.4922 35.6039 31.2515 -3.36872 -19.2676 30.0327 -8832 6 50.5831 9.86782 9.34675 -39.9446 -18.2052 0.719337 -8833 4 49.679 9.5553 9.65542 27.7691 6.62521 -8.8993 -8834 4 50.7343 10.6656 9.84378 7.47556 12.1458 9.31829 -8835 6 49.6659 40.3022 22.5839 -5.95569 -23.2057 2.00246 -8836 4 49.9088 39.3695 22.3976 1.04597 17.1639 -6.42107 -8837 4 49.3089 40.2511 23.4853 9.00681 3.37443 -0.55643 -8838 6 7.21026 41.318 28.8937 -13.882 28.5523 32.2899 -8839 4 7.13277 41.6426 29.851 5.74914 -19.7174 -37.6289 -8840 4 7.14599 0.215754 28.3517 11.7183 -8.26627 3.5395 -8841 6 13.0317 18.008 25.3351 57.1177 45.3919 41.6622 -8842 4 13.702 18.0765 24.6297 -18.9881 -2.87884 -2.05071 -8843 4 13.5608 18.5052 26.1022 -41.5403 -41.2906 -37.5185 -8844 6 50.0508 19.5822 2.43378 8.05757 -12.3534 -25.4868 -8845 4 50.6415 19.2321 1.70522 -9.91294 15.3245 28.3035 -8846 4 50.4964 20.3068 2.88656 9.48594 2.0046 -2.18375 -8847 6 28.3417 40.9623 24.5247 28.1527 -9.28969 -2.11238 -8848 4 28.8808 40.6229 23.7869 -8.53201 1.00989 5.926 -8849 4 27.851 41.6822 24.1702 -24.0642 17.3603 -12.6153 -8850 6 19.4173 5.36544 29.5282 -16.7292 -1.42659 17.4998 -8851 4 20.0576 6.03033 29.2802 12.6037 1.87093 -5.71578 -8852 4 18.8017 5.84191 30.1159 0.735032 -8.12986 -7.95209 -8853 6 35.3107 40.1454 22.2712 -2.40765 19.7984 -7.699 -8854 4 35.7006 39.9699 23.1142 6.54418 -16.9762 14.0951 -8855 4 35.2702 41.1078 22.294 -0.592679 0.794763 -5.20647 -8856 6 16.1889 33.7724 9.7458 10.3229 10.2088 29.582 -8857 4 15.8959 33.2543 9.01299 -6.07516 -13.8809 -16.7379 -8858 4 15.6715 34.5759 9.82028 -7.73583 2.776 -7.11592 -8859 6 17.3675 40.6445 20.2267 0.0256395 24.2963 -9.09373 -8860 4 17.2094 39.7816 20.6122 1.5629 -5.58702 6.23448 -8861 4 17.4758 41.3298 20.9152 1.51783 -13.2527 0.49298 -8862 6 20.5171 9.72867 9.58726 35.059 7.05341 -25.1666 -8863 4 21.2226 9.96362 10.213 -13.2653 -0.810893 -5.91795 -8864 4 19.8248 9.38464 10.113 -26.7953 -13.816 19.6743 -8865 6 47.4426 20.1922 21.3765 55.2231 -18.8128 34.629 -8866 4 48.295 19.6294 21.3384 -41.3243 22.9169 -3.74061 -8867 4 46.9816 20.0754 20.5659 -14.9725 -5.50706 -31.0177 -8868 6 38.4071 40.79 37.8146 12.3234 -22.6201 -9.80787 -8869 4 38.1404 41.7017 37.8605 -3.64711 23.1989 -4.06141 -8870 4 38.2696 40.4362 38.6954 -10.1247 -0.131598 9.15413 -8871 6 4.78578 1.94641 13.1038 0.280311 5.55092 -8.42179 -8872 4 4.79931 1.2475 12.4246 2.88607 5.75183 11.0778 -8873 4 4.58324 1.57529 13.9639 -2.31824 -10.9024 4.61034 -8874 6 46.8249 29.0091 2.16845 3.76482 2.94797 40.2579 -8875 4 46.7332 29.1215 3.14399 -15.0191 0.321828 -28.5005 -8876 4 47.6691 28.5689 2.15078 10.7116 -9.65214 -17.1948 -8877 6 37.4359 26.1653 25.6478 9.30824 1.4869 -5.75173 -8878 4 37.1837 25.5346 26.3178 -5.80587 -7.25577 3.90549 -8879 4 36.6384 26.5534 25.3025 -7.59782 4.42715 -0.0787482 -8880 6 27.3269 4.19583 19.442 5.96538 17.8772 -24.7701 -8881 4 28.0114 4.58146 18.8428 -3.77368 -14.8915 15.8068 -8882 4 26.5277 4.61529 19.0816 -6.14884 -6.84507 9.70558 -8883 6 29.57 35.1706 32.6629 9.65469 -19.4491 -13.9626 -8884 4 29.5306 34.4116 32.0191 -0.1659 24.8691 21.1709 -8885 4 30.4743 35.5004 32.5856 -0.51053 -0.290213 -2.43375 -8886 6 51.6097 27.3863 34.6091 -31.2455 30.913 9.06642 -8887 4 51.929 26.6019 35 16.42 -40.5282 7.55135 -8888 4 52.0725 27.582 33.8009 7.9649 -1.59603 -13.3915 -8889 6 26.2078 15.7281 22.6941 16.538 -21.7488 31.7554 -8890 4 25.9667 16.5615 22.3191 -8.70869 23.0893 -12.8942 -8891 4 26.0629 14.9994 22.0993 -9.54979 -3.97748 -17.7982 -8892 6 36.1239 41.1986 15.4707 -7.45359 -19.8962 -4.3143 -8893 4 35.6999 40.3419 15.2987 -9.47391 11.3121 -0.409552 -8894 4 37.0386 40.9374 15.4513 15.7433 3.85103 -0.545832 -8895 6 18.465 8.81345 11.2165 5.38391 10.0618 1.17025 -8896 4 18.7987 8.15135 11.8182 8.53154 -1.35082 11.1952 -8897 4 17.7161 8.38168 10.8393 -16.7411 -2.38381 -11.2186 -8898 6 30.2088 21.3096 23.2049 -11.6688 7.62645 -9.73036 -8899 4 29.9671 22.1993 22.9248 4.97058 -0.914249 3.78278 -8900 4 29.5299 20.7541 22.7893 7.94877 -1.13118 2.47612 -8901 6 22.73 2.20521 34.8374 1.74432 -25.8699 49.3747 -8902 4 22.3572 1.29354 34.8889 6.16039 22.5731 -10.8251 -8903 4 22.7018 2.4887 33.9486 -6.75325 10.5307 -40.1895 -8904 6 12.6909 2.75059 12.3422 -14.3125 16.3183 -13.6311 -8905 4 12.533 3.61796 11.8786 11.7453 -23.2619 14.9881 -8906 4 13.1336 2.19907 11.6816 1.83842 1.45343 3.2847 -8907 6 24.107 30.0639 14.5719 -73.5796 11.8292 4.65098 -8908 4 23.699 30.7611 15.1345 32.1371 -0.343623 -0.31889 -8909 4 23.2337 29.7156 14.2286 43.085 -3.68866 -7.89372 -8910 6 0.015177 27.9048 22.8533 -2.756 -4.53229 -2.63487 -8911 4 54.6492 28.3778 23.623 -8.36257 -3.01834 -6.1652 -8912 4 54.216 27.6514 22.3224 8.23112 8.70814 10.2495 -8913 6 12.3617 4.4844 25.9108 40.9735 -25.7794 -17.3291 -8914 4 12.201 5.40791 25.8162 -22.6464 21.2272 1.21762 -8915 4 11.6198 4.00067 26.267 -15.5784 4.93476 10.9426 -8916 6 50.6578 14.4652 5.91353 -13.9437 -6.30553 43.3918 -8917 4 51.4397 15.014 5.76935 2.55266 2.90763 -3.8133 -8918 4 50.4787 14.4827 6.92851 9.15248 3.54798 -49.9389 -8919 6 52.5668 22.873 20.1428 -12.6564 -29.9263 -28.8801 -8920 4 52.956 23.3393 20.8718 4.45243 13.9606 14.107 -8921 4 52.7899 23.3428 19.3246 -0.129831 10.341 11.583 -8922 6 43.5892 16.524 12.8775 29.595 -3.78245 -19.1347 -8923 4 44.3058 16.0087 12.3806 -28.6005 27.9094 23.6723 -8924 4 42.7982 16.4888 12.3437 -11.2315 -8.54457 -10.2035 -8925 6 15.9661 16.7487 40.5866 1.44034 32.7745 -1.20572 -8926 4 16.4126 17.3388 39.9207 -12.1014 -18.8104 17.452 -8927 4 15.5985 17.3766 41.2587 12.5036 -14.614 -16.5617 -8928 6 23.4158 18.8712 23.8473 -16.0774 -11.4939 3.2157 -8929 4 23.4518 19.2692 24.728 -0.157295 3.62127 -3.85719 -8930 4 22.4941 18.9757 23.5436 12.0607 -0.266031 2.57498 -8931 6 46.4178 3.27548 31.8952 19.5415 -1.29071 -17.2416 -8932 4 45.5866 3.26999 31.4067 -8.61336 -0.166695 4.01481 -8933 4 46.2657 3.3297 32.8359 -5.35267 1.32166 2.09612 -8934 6 43.4045 41.0584 12.2875 -8.04746 -23.5947 4.76735 -8935 4 43.6693 41.8276 12.7696 6.05224 12.9314 10.8988 -8936 4 43.5172 41.2728 11.3626 0.904796 3.93503 -13.2342 -8937 6 7.4976 32.4756 29.5884 -13.7893 55.6862 -12.0377 -8938 4 8.07142 31.7837 29.8334 27.4303 -26.9633 6.13269 -8939 4 8.04212 33.3166 29.512 -13.0153 -27.2422 -1.65156 -8940 6 4.77821 31.644 22.4997 2.28771 28.4048 16.4959 -8941 4 5.27411 32.2412 23.0928 2.56389 -13.4484 -8.63656 -8942 4 4.12057 32.2584 22.1518 -1.39427 -10.0394 -7.16978 -8943 6 48.879 26.8662 2.67919 -5.86075 -60.7959 24.9619 -8944 4 49.7001 26.7095 3.23946 -26.2991 7.4186 -32.0291 -8945 4 48.3448 25.9902 2.75892 28.4546 51.6452 -6.88552 -8946 6 35.3626 23.261 21.6242 -2.7789 -2.57103 6.54281 -8947 4 36.2261 22.8974 21.81 4.94258 -15.6751 6.88864 -8948 4 35.5426 23.9136 20.9639 -1.02428 17.548 -23.8062 -8949 6 9.79934 37.7758 27.3048 16.52 16.637 17.9603 -8950 4 9.72643 38.6113 27.803 -16.1555 -8.36248 -12.7831 -8951 4 10.5885 37.4189 27.7206 -2.15823 -16.4776 -5.60851 -8952 6 6.95685 10.9812 25.9821 -25.178 -21.2877 -4.97438 -8953 4 6.33357 10.2528 25.7268 23.179 21.9129 0.503821 -8954 4 7.29095 10.6974 26.8328 9.60603 -1.481 14.6966 -8955 6 15.9965 34.4888 38.9273 -2.91878 -3.91161 19.3063 -8956 4 16.0374 33.5463 38.7461 4.95306 -0.665665 -16.4822 -8957 4 15.9715 34.4958 39.9054 -7.59103 5.72172 -22.2107 -8958 6 24.1167 17.3197 36.1615 15.3363 -47.5124 0.380375 -8959 4 24.7173 17.5753 36.8648 1.58194 5.49031 12.5141 -8960 4 24.1546 16.3101 36.2205 -9.7187 30.8811 -7.11116 -8961 6 29.9757 19.0472 5.63639 12.788 -31.6225 11.2379 -8962 4 30.1584 18.5328 6.46799 -12.7316 12.501 -21.5451 -8963 4 29.4206 19.7916 5.84051 -11.4929 16.6696 15.0892 -8964 6 41.2293 14.2018 25.873 -1.75888 28.9255 -23.3251 -8965 4 41.1078 15.0995 25.4693 3.83492 -22.0907 13.098 -8966 4 41.2654 14.3268 26.8215 3.7207 5.50516 9.94654 -8967 6 30.6006 17.7874 37.3562 -24.7598 46.8721 10.074 -8968 4 30.0173 18.4181 36.8416 23.2796 -25.9316 -1.25214 -8969 4 30.633 18.2764 38.2118 8.15578 -14.795 -8.30511 -8970 6 36.2662 35.7599 28.8527 -12.8707 -30.9202 21.2821 -8971 4 36.6718 34.9534 29.2396 -10.1595 12.442 -4.1956 -8972 4 37.0218 36.2801 28.6478 17.3511 22.2532 -11.5483 -8973 6 0.195836 37.8645 20.3851 -23.6217 6.21569 -13.9532 -8974 4 0.549498 37.2778 21.0637 4.94615 -2.95215 -2.70832 -8975 4 54.3862 37.4234 20.0075 16.4722 8.11718 6.90773 -8976 6 49.5165 39.5896 25.2714 -0.622408 -34.3922 32.9891 -8977 4 49.1772 39.7667 26.1925 10.9208 -1.11318 -32.3029 -8978 4 49.8261 38.6352 25.2806 -10.9036 35.658 1.81375 -8979 6 21.6574 10.1952 29.3538 -5.06277 -0.743802 10.2318 -8980 4 21.4664 11.1105 29.223 -3.01111 19.5458 -20.3057 -8981 4 21.662 10.2064 30.3052 9.73006 -17.7161 13.8831 -8982 6 36.4636 30.0567 0.119709 9.37859 61.6807 38.5429 -8983 4 36.3123 29.4684 41.3206 -1.21017 -23.1836 -37.505 -8984 4 36.9143 30.908 41.7057 -13.4567 -39.5067 4.20368 -8985 6 35.2344 23.3726 39.1433 31.8417 -88.9919 -51.9106 -8986 4 35.0278 23.5012 38.2069 -5.96056 -5.38998 8.96032 -8987 4 34.9909 24.127 39.538 -31.8308 96.9265 45.0865 -8988 6 25.4761 17.6258 38.7257 1.29934 8.28965 -16.1346 -8989 4 26.2031 17.0769 39.0234 13.7946 -6.33455 1.86524 -8990 4 25.7107 18.4933 39.0598 1.3782 7.33891 4.86011 -8991 6 32.6846 1.71002 15.3734 -11.6254 -20.3205 21.5399 -8992 4 32.9453 1.93093 16.3086 -8.96834 -8.53877 -20.2534 -8993 4 32.154 0.853232 15.3925 19.204 32.1949 4.36426 -8994 6 2.7574 26.2382 40.1716 -4.40087 -21.6692 -50.7652 -8995 4 2.38718 26.7949 40.8139 -8.13358 26.7101 38.7547 -8996 4 3.41358 25.6429 40.5298 13.0891 -5.49009 7.80053 -8997 6 25.4307 39.5752 6.64887 -26.4755 -1.32722 14.1102 -8998 4 25.8932 39.0809 7.30961 27.038 -6.17916 -3.25304 -8999 4 24.5458 39.4465 7.03066 -2.44587 12.932 -21.9634 -9000 6 3.88975 2.45855 21.1879 28.3389 -91.355 -25.6726 -9001 4 3.44478 1.54109 20.9736 25.4092 48.4753 9.01111 -9002 4 3.19228 2.99847 21.4284 -47.2055 43.8768 12.3888 -9003 6 19.4353 35.9908 6.17834 -1.98144 -11.1023 18.0698 -9004 4 18.7425 35.7628 6.83514 2.39623 12.5316 -16.1317 -9005 4 19.0828 36.5127 5.45195 -11.0597 11.4176 1.1294 -9006 6 53.664 10.8386 34.7899 -0.427116 -3.27611 41.7292 -9007 4 53.6105 10.6836 35.7561 -1.66612 -17.5448 -26.7849 -9008 4 53.9652 11.7272 34.8329 4.68725 29.9217 -18.2793 -9009 6 51.2799 14.0867 34.6651 -29.2798 -10.9719 -23.3019 -9010 4 50.6522 13.5411 34.1107 26.8684 18.9114 5.01949 -9011 4 50.9895 13.8814 35.5479 1.81167 -5.08277 17.6681 -9012 6 14.4338 40.0198 28.0288 -0.147098 23.5255 27.6002 -9013 4 13.7688 39.3521 27.8218 1.28331 -8.25373 7.75106 -9014 4 14.1948 40.5222 28.8704 -0.878391 -19.6822 -29.209 -9015 6 36.0552 40.8569 1.29319 48.4065 13.1893 15.2608 -9016 4 35.4421 41.0883 1.96787 -21.4185 -0.412662 13.5205 -9017 4 36.896 41.2683 1.66088 -27.5471 -12.7345 -18.5843 -9018 6 32.5846 21.8706 9.62772 14.4951 6.80277 0.680584 -9019 4 32.1936 21.3098 8.97285 -7.2875 -23.9506 -7.81502 -9020 4 32.858 22.6104 9.08324 0.955029 10.0343 1.40437 -9021 6 53.7602 11.4574 10.0748 -7.70253 -4.89045 -17.0247 -9022 4 54.6558 11.7035 10.3272 3.70339 -10.2166 -5.16833 -9023 4 53.8328 10.8374 9.31644 -2.27357 5.83713 13.9933 -9024 6 25.443 2.0669 35.0212 -16.7533 17.7231 -21.4763 -9025 4 25.6415 2.91576 34.5502 -7.64634 -16.7974 11.4347 -9026 4 24.4652 2.09352 35.1703 17.3945 -2.11295 -4.26167 -9027 6 38.4088 16.3775 27.0777 23.4896 -26.556 7.92078 -9028 4 38.4029 15.905 27.9411 -0.72651 18.7119 -5.4255 -9029 4 38.1233 17.2789 27.1678 -4.67214 15.3602 11.0072 -9030 6 11.9834 11.8283 38.0863 1.50515 -20.9897 -19.5245 -9031 4 12.337 12.445 38.7318 -5.05033 4.06408 7.46746 -9032 4 11.0493 11.6049 38.244 7.06215 11.5652 6.68382 -9033 6 21.1646 40.7247 25.8949 30.8575 -6.32012 -20.5276 -9034 4 20.7152 41.4784 25.5554 -14.4662 20.9939 -18.0031 -9035 4 20.8194 40.6451 26.758 -13.9443 -15.9826 36.5019 -9036 6 5.45737 31.2526 28.1092 12.1805 15.5126 -2.48606 -9037 4 4.77986 31.7446 27.6301 0.776808 -0.764161 -8.53258 -9038 4 6.21204 31.8695 28.2031 -7.61365 -6.18966 7.74582 -9039 6 38.5666 10.4345 26.6322 12.4833 -8.23035 1.5222 -9040 4 39.2815 10.9281 26.2104 -2.91177 1.8082 -0.00903947 -9041 4 39.0293 9.89744 27.2937 -7.88948 5.75886 -1.98766 -9042 6 34.5704 22.2441 5.77364 -5.35359 -6.12765 6.5276 -9043 4 33.6261 22.329 6.01336 10.9983 8.59631 1.2651 -9044 4 35.1361 22.6291 6.46875 -10.1328 -5.43064 -4.61746 -9045 6 19.508 23.4157 8.91293 -5.78488 4.73981 5.04963 -9046 4 19.7274 23.1974 9.83518 1.16663 -6.94775 -9.92836 -9047 4 19.9131 22.8043 8.29809 9.12387 -6.1547 2.91491 -9048 6 19.7424 39.1606 18.9462 6.36032 12.2479 8.14591 -9049 4 20.3561 39.0422 19.6872 -3.85164 -4.35394 -5.20149 -9050 4 19.0738 39.7495 19.3414 -1.06489 -8.07777 -11.9442 -9051 6 19.0057 16.6591 37.8853 37.3334 -16.7993 4.17439 -9052 4 18.1861 16.4809 37.4823 -32.8062 -2.38488 -19.1553 -9053 4 18.8146 17.2984 38.5514 -2.10283 15.4454 14.1988 -9054 6 46.1541 18.3125 34.4675 -16.9871 7.29415 15.254 -9055 4 46.1595 17.7325 33.7168 0.615393 -10.1859 -17.2384 -9056 4 45.2376 18.6499 34.5058 9.28079 -5.03019 -2.85447 -9057 6 37.6537 4.93165 10.635 20.1552 -8.04423 -16.7256 -9058 4 38.5399 5.21744 10.272 -26.6503 -7.30776 7.98139 -9059 4 37.1074 4.55852 9.88971 22.9932 21.6332 27.1334 -9060 6 51.9792 36.004 6.8478 30.791 3.18545 -0.726681 -9061 4 52.2413 36.7963 6.35992 -14.9215 -4.55469 -2.53046 -9062 4 52.8266 35.8818 7.33626 -22.3254 6.63746 5.40006 -9063 6 26.6741 12.3268 1.0034 -10.7024 -25.4666 -34.2692 -9064 4 26.4988 12.3574 1.94138 -4.81655 1.43394 14.8604 -9065 4 26.0954 11.585 0.663483 16.9242 17.5219 15.4646 -9066 6 51.3423 35.7724 13.5298 -0.266216 29.5034 10.6004 -9067 4 51.4043 36.4131 12.804 2.34884 -4.4098 -1.45811 -9068 4 51.4073 34.9167 13.1542 5.41074 -27.2154 -15.541 -9069 6 1.98873 3.64285 24.5869 25.9971 69.8048 -55.2188 -9070 4 1.65752 3.03018 25.1632 -30.3002 -46.9535 54.3289 -9071 4 1.71436 4.54846 24.8879 2.6309 -26.2008 -0.982747 -9072 6 33.5221 15.2795 16.4506 0.0536135 -15.838 -38.1617 -9073 4 33.6476 15.3964 15.4593 -8.63578 3.82522 35.1416 -9074 4 33.7341 16.1085 16.8736 8.85342 14.4801 4.37501 -9075 6 10.7227 26.5775 37.3442 -67.903 54.2831 -20.645 -9076 4 10.2191 27.0779 38.0369 14.5194 -13.2702 -3.80745 -9077 4 11.4784 26.2608 37.7268 68.0232 -30.094 41.6962 -9078 6 39.6271 8.38119 31.999 1.44949 -5.13238 35.1009 -9079 4 39.1996 8.85287 32.7464 5.61163 -5.5592 -21.3265 -9080 4 39.0885 8.45634 31.2221 -15.3514 9.3045 -12.0182 -9081 6 48.873 24.2439 11.5987 1.10357 -37.2725 -9.21005 -9082 4 49.1825 23.3167 11.4023 -5.65288 27.9965 8.32055 -9083 4 49.5986 24.6511 12.0826 3.19491 3.15896 -2.50749 -9084 6 15.8098 8.51994 22.5326 -12.5814 0.672941 2.19285 -9085 4 15.7588 8.52265 21.5683 10.3815 2.49136 4.36748 -9086 4 15.4206 9.36801 22.7863 6.5895 4.65597 -0.371293 -9087 6 16.9392 23.5364 7.95083 25.1749 21.5498 -34.0775 -9088 4 17.2079 23.9031 7.093 -25.8979 -5.01679 3.50755 -9089 4 17.8126 23.4623 8.29573 16.7216 -7.09478 32.6865 -9090 6 42.4825 26.8555 6.33102 0.60087 7.54144 -12.7632 -9091 4 41.764 27.4892 6.46083 9.75026 1.01062 3.5184 -9092 4 43.14 27.3488 5.78659 -9.42643 -3.33158 7.6404 -9093 6 36.8078 4.79995 30.0438 -4.74249 18.2042 -3.85385 -9094 4 36.952 4.89746 30.9922 3.10706 -1.8894 0.559973 -9095 4 36.294 4.02131 29.8808 -10.4691 -15.4659 3.71438 -9096 6 45.6128 11.6142 3.31163 15.5246 21.1623 13.6733 -9097 4 45.8972 10.701 3.31117 0.727629 -14.3179 7.30305 -9098 4 46.2501 12.0834 3.90994 -13.3278 -10.7206 -15.6492 -9099 6 24.8943 36.3842 21.2731 0.145584 -0.0155718 21.9832 -9100 4 24.5073 36.3627 22.1568 -5.92138 3.86098 -2.91089 -9101 4 25.79 36.6624 21.4916 7.30899 1.2523 -13.3669 -9102 6 31.8172 24.7218 2.44079 24.9542 32.077 -0.738567 -9103 4 31.5948 23.8911 2.82575 -7.26237 -24.1795 3.52598 -9104 4 32.7966 24.7848 2.51706 -20.2581 -1.29655 -5.98664 -9105 6 24.135 21.9795 37.225 -18.6422 57.7065 19.5247 -9106 4 24.1223 22.9841 37.1061 1.06209 -41.2434 9.50937 -9107 4 24.7129 21.6948 36.5371 13.1815 -12.7877 -24.1492 -9108 6 37.1979 11.5342 15.06 20.8972 -17.7328 -40.5152 -9109 4 38.0246 11.7972 15.4709 -1.33045 5.21986 19.7962 -9110 4 36.429 11.9138 15.4438 -18.178 22.6449 25.793 -9111 6 36.4751 20.3399 41.7845 -26.5497 -48.0551 41.2862 -9112 4 36.3228 19.4621 41.3748 1.60744 11.8178 -3.29004 -9113 4 36.9246 20.873 41.191 27.5593 28.4699 -43.2619 -9114 6 32.0497 37.9214 32.6612 -32.2386 -8.50634 -18.7459 -9115 4 32.4337 38.7163 32.9803 20.8647 20.5609 12.2985 -9116 4 31.3654 38.2694 32.0613 5.31663 -14.2519 5.69849 -9117 6 12.0395 39.928 22.5123 -26.9832 36.7812 23.3187 -9118 4 12.2839 40.8414 22.1926 -3.01474 -29.6796 4.86816 -9119 4 11.2932 40.0883 23.1662 29.524 -10.585 -25.0576 -9120 6 26.3406 1.33526 19.2893 15.6729 -20.8034 13.8388 -9121 4 26.8411 0.655996 19.8199 -14.5491 24.9752 -14.9066 -9122 4 26.8003 2.1813 19.3861 0.112049 0.00336314 -1.02908 -9123 6 5.91669 14.3164 5.69097 2.29729 -16.5161 -30.3395 -9124 4 6.30102 14.1024 4.7902 -6.32478 5.25084 23.5077 -9125 4 5.06552 13.8494 5.70115 7.33482 -6.30923 1.55114 -9126 6 13.3703 23.089 19.1627 -28.3895 15.3871 14.4757 -9127 4 14.1086 22.8122 18.6632 27.2898 -8.01563 -16.6587 -9128 4 13.6991 23.742 19.8005 3.67942 -13.964 0.879599 -9129 6 23.4058 15.0688 9.73621 -4.11719 1.06855 12.2005 -9130 4 22.5732 14.661 10.02 0.657405 4.9462 -7.25364 -9131 4 23.2196 15.7347 9.05868 -5.70535 0.38861 -5.0655 -9132 6 49.5812 13.8288 18.4474 0.101153 1.0527 41.008 -9133 4 48.8214 13.4814 17.9923 -8.96247 -7.71084 -15.1851 -9134 4 50.2052 14.1722 17.8367 10.7879 13.5653 -33.2962 -9135 6 41.7444 5.67096 41.8915 25.5819 0.859229 17.1787 -9136 4 42.5704 5.9364 0.475256 -21.6624 -6.74737 -14.5764 -9137 4 42.0361 4.9893 41.2645 -5.04703 6.59959 -2.77397 -9138 6 17.2492 35.5437 2.55512 -4.98919 17.2489 6.23124 -9139 4 18.1963 35.629 2.41282 7.59523 -3.20753 1.41995 -9140 4 16.9663 34.6563 2.38439 4.57262 -16.6324 -5.73806 -9141 6 49.6936 19.8647 40.242 36.1149 -8.05295 1.41344 -9142 4 49.24 19.0314 40.466 10.1916 2.45634 3.62304 -9143 4 50.6901 19.7225 40.3055 -34.6505 -2.12616 -4.55887 -9144 6 38.3055 5.83107 32.0437 -25.1209 3.13983 17.5072 -9145 4 37.8566 6.51058 32.5952 5.57321 -12.5864 -8.78808 -9146 4 39.2068 6.11217 32.0045 20.6085 6.27671 -1.8315 -9147 6 16.2656 6.85278 34.0134 13.6308 -7.44031 -0.955967 -9148 4 16.5278 6.7006 33.1016 -0.686465 1.61317 -6.98637 -9149 4 17.0706 6.57794 34.496 -11.7464 5.49098 9.02554 -9150 6 33.6779 18.1919 10.4599 39.833 -25.9405 -6.08719 -9151 4 34.2274 18.843 9.984 -7.48822 -11.4027 6.26591 -9152 4 34.2403 17.3374 10.5556 -30.6671 44.9369 -7.76686 -9153 6 38.8896 33.7563 36.7672 22.7659 10.9801 -36.8997 -9154 4 38.4264 33.5452 35.9055 8.66825 7.19978 21.2858 -9155 4 39.8358 34.0039 36.5278 -27.7603 -15.0244 3.77145 -9156 6 45.3747 13.0912 20.2115 -8.54575 18.1695 38.2532 -9157 4 45.1986 12.6554 19.3957 -4.2418 -14.8759 -23.2281 -9158 4 44.5273 13.1029 20.6991 7.89471 -4.73094 -13.0554 -9159 6 36.3919 32.2126 8.83938 1.15121 -2.28434 -1.4136 -9160 4 36.3207 31.3933 9.34391 1.93757 3.36082 7.91897 -9161 4 36.0586 32.9456 9.38554 -3.10773 -8.06217 -4.51958 -9162 6 7.93399 27.8164 6.18652 -8.84441 8.26416 -30.5327 -9163 4 8.20753 27.2416 6.88401 9.15323 -7.03573 14.7081 -9164 4 8.30192 28.6748 6.41842 -5.04409 0.971707 0.751098 -9165 6 14.2889 4.87494 33.6812 -48.074 -5.72289 -27.637 -9166 4 13.5426 5.15568 33.0467 38.2298 -5.02982 23.8683 -9167 4 14.8103 5.65434 33.8518 10.0815 16.0504 2.39638 -9168 6 12.247 8.64363 9.86387 9.5307 8.47707 -42.9656 -9169 4 12.7265 8.83196 10.6522 4.83417 -1.95201 32.3898 -9170 4 11.3733 8.28369 10.003 -7.27928 -7.56138 14.4849 -9171 6 29.7193 31.982 8.5339 -11.3757 5.45371 -22.6092 -9172 4 30.2272 31.7973 9.28681 18.5431 -1.21859 37.4341 -9173 4 29.7513 31.1489 8.05875 -9.95983 -0.182644 -6.87416 -9174 6 22.3912 10.8818 21.4749 22.6973 -30.3469 0.856054 -9175 4 21.7953 11.1177 20.7819 -19.5872 13.8984 -18.5017 -9176 4 22.3568 11.5583 22.1363 -13.7305 16.7548 8.89642 -9177 6 54.1825 27.5382 12.9949 16.0749 -34.873 29.2784 -9178 4 0.169556 27.5337 13.075 -9.84187 5.32432 -2.29215 -9179 4 53.8855 28.25 12.4714 -3.97587 36.1158 -26.3516 -9180 6 7.7322 13.8127 20.037 -51.4252 10.19 -38.2554 -9181 4 8.32211 14.101 20.6974 26.6579 16.8549 28.1402 -9182 4 7.28001 14.6396 19.6917 19.816 -24.9044 7.79538 -9183 6 19.8038 0.841082 24.7751 2.23798 25.7663 18.7115 -9184 4 19.2888 0.974936 25.5977 -1.44078 2.26272 -14.328 -9185 4 20.345 1.66892 24.688 -12.1486 -28.8133 2.35345 -9186 6 3.00622 10.0987 2.94957 -26.3714 23.4248 -9.90714 -9187 4 2.57802 10.9845 2.80681 8.85648 -28.8297 5.38 -9188 4 3.90714 10.2978 3.18407 20.8138 3.7803 5.2 -9189 6 15.8735 13.0135 24.0167 27.3456 -6.4848 -7.35342 -9190 4 15.0397 13.4574 24.067 -14.2007 12.8972 1.61729 -9191 4 16.3075 13.2711 24.8409 -0.511489 -7.63656 -0.0548578 -9192 6 17.0843 4.34635 26.9246 21.6007 -4.50946 14.2865 -9193 4 16.8972 4.2188 26.0046 2.50265 0.324122 -20.691 -9194 4 18.0611 4.2338 26.9976 -18.2314 5.96709 -0.11875 -9195 6 33.6189 39.4094 10.6341 -20.462 51.0085 -28.6484 -9196 4 33.9391 38.663 11.0702 20.9333 -51.253 8.17882 -9197 4 33.8334 39.409 9.67256 -1.15733 -4.02232 18.0774 -9198 6 36.2391 1.10544 13.1071 -14.4853 9.25302 -40.2412 -9199 4 35.5849 0.422507 13.2928 -0.138393 -8.38057 10.5121 -9200 4 36.8138 1.26142 13.8363 9.41155 -3.27129 23.8008 -9201 6 40.853 19.2974 5.10856 37.2457 -28.9827 71.4026 -9202 4 40.5429 19.587 4.3016 -40.6732 16.7295 -57.0845 -9203 4 40.1307 19.0416 5.7147 0.644924 10.2678 -10.4268 -9204 6 2.34714 37.5568 10.1845 35.9634 7.02123 17.8242 -9205 4 3.04769 37.1203 10.7322 -14.847 6.26565 -12.1612 -9206 4 1.86424 36.8893 9.71962 -14.8151 -24.6966 -11.8987 -9207 6 8.10127 29.0413 15.8656 35.302 -29.7249 12.8686 -9208 4 9.00843 28.6191 15.9508 -31.5464 15.4715 -14.0583 -9209 4 8.16404 29.7921 16.4466 -1.11054 13.1495 4.82257 -9210 6 47.3142 26.5199 12.5393 12.6514 34.6971 -22.5506 -9211 4 47.5805 27.2834 11.915 -17.373 -39.4708 28.4474 -9212 4 47.3752 25.7188 12.0092 -0.907674 -0.00416251 -5.94845 -9213 6 33.5917 17.5154 0.659811 -43.6991 -50.8046 22.4668 -9214 4 32.6165 17.4611 0.916402 33.9721 22.4374 -10.1482 -9215 4 33.8023 16.5556 0.790839 15.7196 25.0769 -8.55135 -9216 6 38.9785 15.6005 36.3846 -2.2974 -5.19358 -9.56289 -9217 4 39.1604 14.6481 36.4599 -0.972636 7.263 -3.41001 -9218 4 39.314 15.9159 35.5329 5.29716 -3.31476 -2.44888 -9219 6 34.8185 34.3512 9.36223 6.47638 -43.1481 -28.0847 -9220 4 35.4473 34.9875 9.0418 9.26483 22.2324 -9.2882 -9221 4 34.4241 34.6992 10.1221 -17.9819 29.7233 40.2724 -9222 6 44.963 2.56985 14.7807 31.4374 15.1132 5.36654 -9223 4 44.0324 2.49792 14.9225 -24.9873 -3.38313 6.1219 -9224 4 45.264 3.39221 15.2058 -8.16761 -2.00961 -7.57881 -9225 6 42.6004 38.2794 19.8329 35.0217 22.8895 -33.2683 -9226 4 42.7468 39.1886 19.4383 -9.39889 -30.5105 9.50416 -9227 4 43.174 37.7101 19.2395 -23.2435 10.9907 19.5876 -9228 6 18.6884 26.768 30.2631 -44.5574 -6.69712 -17.565 -9229 4 18.1049 26.7773 29.4546 19.8507 -1.43152 25.0232 -9230 4 19.5658 26.9377 29.9555 24.8572 5.14496 -8.76909 -9231 6 38.8622 37.7231 16.4658 -22.8479 4.5656 13.1257 -9232 4 38.7902 36.7734 16.2818 1.44729 8.74588 -1.32739 -9233 4 39.7766 37.9619 16.5567 26.2519 -3.67716 3.06508 -9234 6 49.2941 9.82087 12.5338 42.2108 35.2088 45.7943 -9235 4 48.9089 9.29765 11.888 -36.0338 -29.0733 -40.4243 -9236 4 48.6148 10.195 13.1058 -6.01968 0.395602 -5.44143 -9237 6 43.2224 7.37144 19.82 -8.13737 3.26926 23.5272 -9238 4 42.5007 7.77471 20.3735 21.5488 -7.79487 -11.5807 -9239 4 44.0862 7.49788 20.2643 -6.92785 0.102081 -4.68832 -9240 6 36.344 38.7219 4.42923 6.60518 -8.27287 -3.54737 -9241 4 36.8681 39.515 4.62823 -9.591 -1.38231 4.53716 -9242 4 35.4251 38.8858 4.67742 1.90858 4.69501 2.45497 -9243 6 27.7906 17.7903 15.1063 3.75124 -7.8529 -14.6222 -9244 4 27.6041 16.8818 14.7764 0.112743 20.8749 5.00331 -9245 4 27.89 17.7299 16.0573 -1.67078 -3.69001 6.73869 -9246 6 18.0934 3.7697 37.3166 -37.4896 -7.94699 -19.9181 -9247 4 18.6099 3.0373 36.9676 7.8944 1.98274 4.30106 -9248 4 18.6508 4.23334 37.9126 25.9725 10.5984 22.5053 -9249 6 7.70643 11.5866 6.5218 3.89219 -35.3855 26.5153 -9250 4 7.81247 12.3986 6.99593 -0.830342 19.7116 4.35361 -9251 4 7.69429 11.7375 5.59555 -1.18048 8.56411 -33.1609 -9252 6 31.493 14.3493 18.0362 -8.33789 -14.4781 24.6772 -9253 4 32.1359 14.6991 17.4236 11.1505 2.18599 -11.6706 -9254 4 31.9992 13.8221 18.6877 -1.72215 8.99473 -5.41338 -9255 6 50.3257 30.4119 8.91981 13.6638 2.66477 0.921327 -9256 4 49.6699 30.7962 8.33415 -6.09837 5.9585 -1.44957 -9257 4 50.0726 29.5063 9.09532 -3.6785 -2.74239 1.52637 -9258 6 42.1666 10.1001 12.7665 27.8846 0.568566 -7.78474 -9259 4 41.2574 9.89168 12.6212 -25.0269 -7.71108 -1.23548 -9260 4 42.2044 10.927 13.2385 -4.76175 6.29789 8.61568 -9261 6 37.7726 3.10257 32.5651 17.7286 -33.908 -11.3576 -9262 4 38.1655 3.96622 32.6549 -5.80606 19.6252 0.391082 -9263 4 36.8286 3.11418 32.7073 -14.5698 15.7581 5.48125 -9264 6 35.7529 13.1025 19.269 15.6222 -22.7979 5.95892 -9265 4 36.108 13.8438 19.7616 3.89933 6.86159 4.70877 -9266 4 36.3275 12.3403 19.5267 -16.9537 12.3267 -5.61016 -9267 6 45.5307 4.12701 21.4866 3.53751 -14.4086 10.8893 -9268 4 45.552 4.15257 20.5178 1.20389 1.85135 1.62688 -9269 4 45.7304 3.20168 21.7391 -1.66454 15.9633 -13.005 -9270 6 16.8818 1.84763 31.4809 -38.7514 34.7723 -17.791 -9271 4 16.1373 2.3559 31.0688 16.7124 -32.2776 -3.52377 -9272 4 16.9707 2.38347 32.2636 22.4894 -8.71684 18.7287 -9273 6 14.088 4.88632 23.5804 12.6338 -46.5447 -4.7054 -9274 4 13.8705 5.7909 23.7155 -14.7558 31.001 11.1078 -9275 4 13.7332 4.31383 24.2952 -4.17517 18.1368 -8.36436 -9276 6 38.3179 33.7515 12.3711 -25.6361 -5.15185 -28.4625 -9277 4 38.1256 32.9508 11.8227 6.04426 17.9062 13.2724 -9278 4 39.1779 33.654 12.756 21.0695 -5.21903 12.1581 -9279 6 35.6902 3.04562 37.6746 -3.39904 8.35156 -7.25132 -9280 4 35.0929 2.54933 38.2324 -5.1037 -10.0227 3.00486 -9281 4 35.8394 3.86187 38.1597 5.81883 9.20211 1.39187 -9282 6 31.3375 37.3986 35.3773 -3.71028 -11.6357 31.0668 -9283 4 32.2621 37.6229 35.4422 12.7398 8.80293 9.59752 -9284 4 31.1956 37.5429 34.4696 -8.56261 0.879722 -41.7472 -9285 6 52.0699 11.7425 14.0188 13.7235 -2.71131 -30.9774 -9286 4 51.8967 11.0942 13.2788 12.7756 18.36 20.3091 -9287 4 52.777 12.3878 13.7226 -29.9657 -23.6346 9.26958 -9288 6 26.3494 3.44143 41.0133 25.155 -37.875 16.6614 -9289 4 25.5593 3.94137 41.1232 -17.1598 23.2709 -17.7277 -9290 4 26.8278 3.58917 40.1822 -8.59815 12.7626 -4.44352 -9291 6 24.371 34.9599 11.1571 26.4033 32.6711 -2.50587 -9292 4 24.3639 34.5741 12.011 0.42503 -6.32387 38.1824 -9293 4 23.9976 34.2869 10.6415 -25.866 -31.4028 -29.8537 -9294 6 32.0031 7.59722 31.2247 -0.72006 7.33901 18.8157 -9295 4 32.1508 7.36357 30.327 0.345644 0.817488 -27.7554 -9296 4 31.6126 8.48818 31.2118 -2.13527 -8.40442 2.30992 -9297 6 28.7291 2.6069 0.424694 -24.9548 -1.7826 -18.2237 -9298 4 29.2265 2.34055 41.548 2.55638 3.32464 9.52498 -9299 4 27.7798 2.59721 0.142899 25.7986 3.33204 9.63582 -9300 6 42.1267 19.2107 9.86358 19.9254 -1.00598 31.807 -9301 4 42.7282 19.2504 10.675 -28.0191 -3.63038 -32.4782 -9302 4 41.4654 18.506 9.99331 2.41107 5.70909 -2.24499 -9303 6 33.0117 27.0899 8.33041 6.96541 -9.8522 -22.9567 -9304 4 33.8754 26.9804 7.88875 -4.89246 2.6856 6.68054 -9305 4 33.1889 27.2976 9.23992 7.88062 7.04275 14.0068 -9306 6 4.17016 8.31297 19.162 0.312608 -23.727 -31.8356 -9307 4 4.57057 7.90515 18.3575 7.98956 13.418 22.158 -9308 4 3.24181 8.25888 18.9046 -6.31749 7.79174 9.16769 -9309 6 20.797 29.1851 37.0682 -78.8245 -16.0462 -5.4556 -9310 4 20.936 28.2326 36.9784 16.4861 -0.723813 3.66436 -9311 4 21.5674 29.6886 37.0761 54.0195 18.5923 4.39527 -9312 6 13.113 4.99943 10.9253 0.843453 12.9862 -7.21248 -9313 4 13.3812 5.91092 11.1622 0.48683 -16.0572 0.936043 -9314 4 12.7752 5.03128 10.0238 -4.21215 6.55392 -0.64752 -9315 6 37.5015 18.1018 32.5195 21.2703 25.6519 14.9603 -9316 4 38.1786 18.7738 32.2234 -25.3038 -17.5123 8.13315 -9317 4 37.1867 18.4103 33.3985 6.70568 -0.056708 -13.7279 -9318 6 17.7491 33.2689 30.7387 4.64458 14.8517 -20.1826 -9319 4 17.8421 33.9996 30.1068 1.39741 -2.79987 6.34018 -9320 4 18.5541 33.2627 31.2599 6.50121 5.74528 2.59283 -9321 6 23.1871 32.777 9.90494 7.13269 10.4795 -4.3903 -9322 4 23.4604 31.94 10.2921 1.41378 -5.3263 0.807867 -9323 4 22.2339 32.7251 9.74224 0.938735 -0.283076 -0.953242 -9324 6 14.8916 9.36878 34.2544 -3.17606 -9.25219 -4.09189 -9325 4 15.4257 8.57154 34.1751 4.23415 -4.52565 -0.814207 -9326 4 15.1936 9.94604 33.5417 3.33837 13.7034 4.88209 -9327 6 31.123 39.3556 38.5725 10.4581 -15.7875 9.507 -9328 4 31.6408 38.6334 39.0195 -17.0405 19.4438 -10.5616 -9329 4 30.3963 38.9123 38.1137 2.26745 0.847431 0.999129 -9330 6 5.28935 34.441 28.2777 -1.85934 -10.7383 -20.8922 -9331 4 5.27738 35.3973 28.3959 -1.64374 -0.931958 4.82044 -9332 4 5.15855 34.3195 27.3212 3.56171 0.206479 13.9304 -9333 6 30.3161 21.6889 14.1169 -2.08187 28.5408 26.4102 -9334 4 30.4824 20.7856 14.3415 3.20532 -20.0191 -7.60805 -9335 4 30.3589 21.8902 13.1869 1.55029 -10.1196 -17.5522 -9336 6 23.85 39.0046 28.2977 69.4329 26.2515 4.57453 -9337 4 23.9916 39.6084 27.5499 -13.57 2.08121 2.63988 -9338 4 23.036 38.5875 28.2612 -60.5143 -23.8938 -11.8576 -9339 6 9.59742 13.5396 16.4589 33.261 19.9292 -8.86772 -9340 4 8.78625 13.0496 16.3926 -14.9619 -4.96746 -5.567 -9341 4 9.78335 13.9533 15.5888 -9.09133 -14.4247 9.50074 -9342 6 25.9705 6.17968 15.7985 42.799 -23.1477 28.9675 -9343 4 26.019 6.01901 14.8637 -2.75181 4.35539 -17.3872 -9344 4 26.7603 5.64791 16.135 -36.9143 25.7793 -10.0513 -9345 6 15.9952 33.6108 22.5498 -1.32684 21.179 0.174096 -9346 4 16.0845 34.132 21.7265 -5.08009 -17.3545 9.33233 -9347 4 16.0452 32.6693 22.2946 2.44519 21.8582 -2.86748 -9348 6 40.6954 13.5457 12.1293 -5.68603 3.79069 10.9638 -9349 4 40.3939 13.0592 11.3555 -1.07855 -14.0058 -3.54454 -9350 4 41.0539 12.9031 12.7626 -3.06611 3.62129 -5.67307 -9351 6 35.5822 40.2773 31.6862 -1.2862 -13.706 14.6905 -9352 4 36.0451 40.9783 31.2154 -1.32327 -4.34646 -14.1397 -9353 4 35.653 39.3915 31.2603 0.648621 22.1552 -3.29488 -9354 6 19.3539 17.5757 17.8527 24.8545 64.4629 -5.36553 -9355 4 19.9703 18.4106 17.9379 -31.776 -45.1138 0.798127 -9356 4 18.7059 17.8424 17.1823 2.41282 -7.28307 3.58563 -9357 6 7.95249 28.0742 10.7793 26.3782 25.043 4.49745 -9358 4 8.50313 28.8396 11.0908 -15.1612 -19.5627 1.83511 -9359 4 7.20779 28.4792 10.322 -5.34026 -2.34355 -4.06419 -9360 6 32.1473 39.5951 16.6478 -17.9563 1.55165 -8.91142 -9361 4 31.6569 40.3908 16.3404 14.2892 -12.9666 6.03874 -9362 4 31.5266 38.8716 16.4637 6.06753 4.48602 8.64925 -9363 6 35.7883 2.63292 18.1275 9.48574 -34.9606 14.0071 -9364 4 34.8666 2.32593 18.1793 13.7366 6.70894 -2.41967 -9365 4 35.7792 3.51083 17.8116 -6.62646 29.9084 -15.3578 -9366 6 14.9404 39.9496 36.887 -3.95865 -34.2615 35.0372 -9367 4 15.4649 39.4425 36.2826 11.0028 -6.45738 -16.6057 -9368 4 15.0284 40.8419 36.6608 5.56286 51.7396 -15.8162 -9369 6 18.3052 32.4025 11.469 7.68428 8.43447 19.219 -9370 4 18.6311 32.5236 12.4045 -8.3236 -1.07971 -30.5152 -9371 4 17.8613 33.2392 11.223 7.02035 -14.738 0.639166 -9372 6 14.6021 10.381 5.00501 12.904 -5.64335 9.41677 -9373 4 13.6938 10.4305 4.69945 -10.3065 0.63937 1.1744 -9374 4 14.613 10.0418 5.92181 -1.23128 6.20644 -15.3767 -9375 6 2.02771 14.3355 39.1727 -5.84559 30.0988 4.34298 -9376 4 2.70173 15.0418 39.0898 -4.78946 -14.8923 5.30178 -9377 4 1.28797 14.7602 39.6738 10.0694 -17.377 -15.1558 -9378 6 7.58332 14.1556 32.4652 3.8824 27.7869 10.7592 -9379 4 6.9433 13.665 32.9756 -4.43494 -6.18284 1.69377 -9380 4 7.54129 15.0698 32.8492 6.23928 -24.1467 -15.6449 -9381 6 6.15722 23.1341 37.6504 -34.5618 -50.1938 -2.0692 -9382 4 6.56488 23.96 37.7745 13.4151 41.4847 -0.267706 -9383 4 5.38195 23.2242 37.0516 20.9526 5.02196 8.70483 -9384 6 37.2952 22.537 4.44472 51.3933 75.9823 3.75371 -9385 4 36.5074 22.1342 4.18978 -47.7056 -22.8011 -17.3868 -9386 4 37.221 23.5361 4.21623 -3.53185 -51.7458 12.1203 -9387 6 47.1368 31.0168 5.89375 -14.3926 17.1884 -69.1718 -9388 4 46.9718 30.7968 6.77028 -10.6218 -7.91998 56.0799 -9389 4 46.2684 31.351 5.53353 23.0456 -16.9797 4.17914 -9390 6 54.8109 25.5937 34.9376 16.0179 27.3393 -6.0446 -9391 4 54.0726 25.4665 35.5517 -1.08617 7.29827 -2.61058 -9392 4 0.161491 26.54 35.0366 -21.9365 -36.0956 3.57937 -9393 6 37.1499 2.07739 4.80452 -1.94348 22.0087 -45.3652 -9394 4 36.668 2.89852 4.54683 5.06511 -19.4283 11.9563 -9395 4 37.1062 1.96831 5.73813 -4.74438 -1.19387 27.2393 -9396 6 22.5142 28.609 8.91066 14.7838 -0.767913 33.3492 -9397 4 22.9803 28.3541 9.73828 -15.565 12.7605 -7.61321 -9398 4 22.8168 27.9481 8.31925 3.93055 -13.9923 -25.0246 -9399 6 8.64284 27.1533 24.5627 -30.3364 66.7798 9.61681 -9400 4 7.68564 27.0552 24.6389 4.16714 -15.7471 -5.05425 -9401 4 9.10482 26.3676 24.4825 22.9633 -64.4218 -6.53839 -9402 6 1.14841 23.7276 2.43845 3.37143 2.75553 -28.3576 -9403 4 1.24451 23.8913 1.47114 -2.40676 3.6179 20.3541 -9404 4 0.297784 23.2877 2.48462 -2.13531 -2.42607 6.29474 -9405 6 54.3749 30.2279 27.0351 -1.87188 5.01086 -25.6864 -9406 4 54.247 29.4439 26.4851 0.283672 1.58093 2.67322 -9407 4 54.589 30.9178 26.3677 -1.31459 -2.18642 16.2549 -9408 6 0.382292 8.43516 23.9819 16.8945 -11.9539 9.7221 -9409 4 1.32445 8.60369 24.1565 -2.20413 -11.2301 -8.89161 -9410 4 54.9553 8.73001 24.7921 -9.77823 11.7559 2.768 -9411 6 16.9131 28.5848 33.3683 -2.23593 -25.3201 -21.0962 -9412 4 17.3654 28.7863 34.1955 9.02781 -2.88055 -0.915496 -9413 4 17.3951 27.8627 32.8656 -13.2947 27.9561 26.4245 -9414 6 33.6945 30.8881 0.140848 11.5734 5.16226 7.65985 -9415 4 34.5903 30.4955 0.196618 -6.50407 7.83028 -3.90982 -9416 4 33.2725 30.4522 41.313 0.902851 -8.5209 -4.03004 -9417 6 16.2572 21.5133 34.1618 -1.32279 -12.2579 -0.0768877 -9418 4 15.8666 20.7686 33.6578 14.5936 10.7995 5.0381 -9419 4 16.7742 21.1109 34.8905 -13.5083 8.43335 -11.1581 -9420 6 0.208862 17.804 35.7536 -14.601 -29.9007 -2.72034 -9421 4 54.2286 17.807 35.5323 33.4083 9.0609 14.8615 -9422 4 0.362977 16.9429 36.1939 -0.60553 13.4006 -6.21859 -9423 6 16.8205 12.2987 0.018055 22.2965 10.2312 29.8095 -9424 4 17.2696 12.8062 0.753963 -11.4311 -8.71934 -28.0399 -9425 4 16.617 11.4478 0.422257 -11.1364 1.3302 -4.58262 -9426 6 8.24969 9.53941 36.253 -15.0171 13.8578 -6.15226 -9427 4 7.92627 8.96163 36.9484 -10.0154 -4.61382 -0.313479 -9428 4 7.46687 9.9886 35.83 14.4541 -3.15884 14.1629 -9429 6 48.5699 26.7153 39.8372 -6.05787 -6.72914 15.0837 -9430 4 48.3449 26.8926 38.9385 -16.4424 3.29077 -18.6566 -9431 4 49.4571 27.0352 39.8842 23.4859 3.73228 5.76721 -9432 6 35.4844 1.07048 23.1169 11.4549 30.8088 37.1655 -9433 4 36.0158 1.76714 22.6808 -9.17201 -14.7916 0.90361 -9434 4 35.6328 1.27141 24.1103 0.373025 -19.0496 -44.6811 -9435 6 20.2784 30.6315 19.3752 23.9103 -21.6662 15.3888 -9436 4 20.3116 31.0532 20.259 -5.42732 -3.95571 -8.57186 -9437 4 20.9344 29.8759 19.4191 -22.0709 25.9102 -5.54449 -9438 6 44.3706 15.9499 1.58551 5.68582 14.4456 12.9619 -9439 4 44.3685 15.5676 2.49167 2.87795 14.7015 -16.764 -9440 4 44.6274 16.9163 1.6094 -6.5628 -31.3198 6.45039 -9441 6 53.8881 34.4681 10.5864 -33.0496 11.7448 -26.9592 -9442 4 54.422 34.2751 11.3149 32.4161 -9.35278 40.7994 -9443 4 54.2788 35.2396 10.1584 -0.0979649 -6.0993 2.73708 -9444 6 46.1388 32.8516 33.5211 5.22207 -15.0187 3.22626 -9445 4 45.9452 33.6327 33.0044 -1.75723 11.2428 -3.91525 -9446 4 47.0422 32.5752 33.2841 -5.1447 4.42718 0.252344 -9447 6 42.1248 21.9061 24.225 29.3467 -8.59285 14.1471 -9448 4 43.0897 21.6191 24.2618 -39.2895 4.06832 7.69751 -9449 4 41.7308 21.6944 25.1042 13.707 1.91177 -18.5137 -9450 6 8.13464 3.90485 11.6471 19.3767 -1.70453 -18.8264 -9451 4 7.33962 4.19894 12.0861 -8.05938 -6.79837 10.6821 -9452 4 8.35918 3.01511 11.9412 -4.68297 1.80025 9.46807 -9453 6 19.6422 41.6776 9.83213 -10.6455 12.1827 13.5714 -9454 4 18.8651 41.1405 9.66265 4.99962 -3.76564 -7.41899 -9455 4 19.3487 0.264237 10.6212 9.02518 -11.5641 -14.6522 -9456 6 42.3073 8.42404 31.6799 28.9247 6.2763 -10.2166 -9457 4 41.4386 8.38933 32.0551 -18.7028 2.48038 0.978172 -9458 4 42.5266 9.37939 31.5704 -3.99861 -19.3235 1.7837 -9459 6 26.9144 16.155 25.3557 3.37886 4.46922 -29.1574 -9460 4 26.8932 15.8089 24.4276 -4.09623 14.1183 21.5023 -9461 4 26.5944 15.4425 25.8888 -2.2842 -17.5105 15.3426 -9462 6 48.2339 6.48607 12.6213 -2.32796 -4.32122 -9.13051 -9463 4 48.9884 6.29985 12.0375 -6.36801 1.93824 2.64233 -9464 4 47.4521 6.15437 12.1363 8.14441 0.739204 7.03502 -9465 6 53.4551 41.5313 30.6545 -6.55363 -20.9747 -16.7061 -9466 4 53.9707 41.8328 29.895 1.38615 3.54438 2.31965 -9467 4 53.5938 0.199493 31.3858 11.9182 14.0856 15.8016 -9468 6 47.0766 22.4304 31.8083 3.49024 11.2606 -9.33253 -9469 4 47.8957 22.458 31.249 -27.0486 7.80914 13.6686 -9470 4 46.5597 23.2507 31.6033 14.3992 -20.3875 6.89099 -9471 6 19.5103 5.43818 15.252 80.4346 7.77941 -36.259 -9472 4 19.9845 4.58151 15.2093 -6.94904 10.3389 3.32724 -9473 4 18.6939 5.26573 15.6196 -64.0069 -9.45641 27.6942 -9474 6 14.6723 30.2358 33.3977 29.3194 14.0021 -15.573 -9475 4 15.2147 30.9127 32.9173 -16.9191 -15.4944 5.99358 -9476 4 15.2716 29.4658 33.3729 -9.39086 7.05787 2.01807 -9477 6 28.44 24.2314 10.4028 3.15123 -12.4056 -9.54268 -9478 4 29.226 24.4262 10.8786 32.4584 2.85658 2.79411 -9479 4 27.8296 24.5485 11.0342 -36.3144 6.15546 12.0187 -9480 6 5.27118 14.4387 24.4945 35.1445 25.2092 -0.0633509 -9481 4 4.43594 14.1516 24.7736 -48.8682 -19.2375 4.52664 -9482 4 5.4685 14.0235 23.6561 -3.04719 -11.4521 -9.99341 -9483 6 26.3524 19.2908 19.1818 20.1263 -20.0506 -24.4735 -9484 4 26.6388 20.1349 19.5116 -1.98461 18.5008 5.62334 -9485 4 27.0961 18.9592 18.5977 -26.1102 9.18548 27.2368 -9486 6 28.5758 7.44193 13.1857 16.8206 36.5977 2.40675 -9487 4 28.4276 6.5743 12.8854 -8.83608 -34.241 -6.14436 -9488 4 29.1296 7.84613 12.4994 -7.23682 2.38597 3.89632 -9489 6 5.36882 27.1473 37.046 11.8823 -4.88323 19.1587 -9490 4 6.08575 26.9595 37.7076 -19.1456 -1.45009 -21.6041 -9491 4 5.36685 28.0942 36.8598 5.86896 -0.355799 -4.60773 -9492 6 53.1378 13.4025 16.0996 34.2435 -3.86055 5.06914 -9493 4 54.0829 13.0966 15.9504 -32.0077 5.91706 2.7318 -9494 4 52.5847 12.6783 16.4422 5.4814 -0.344951 -11.4066 -9495 6 45.452 1.01889 24.6154 3.31322 11.7394 9.54943 -9496 4 44.8157 0.989703 23.8982 -3.33354 -4.25493 -1.52857 -9497 4 44.9019 0.844105 25.4008 9.82267 -2.51687 -6.81685 -9498 6 50.1641 2.37547 13.9256 -5.79196 7.9049 4.59273 -9499 4 50.7992 2.78767 13.3238 -3.84891 -0.754592 0.637936 -9500 4 49.4746 3.0334 14.0873 2.34893 4.7321 -2.13859 -9501 6 19.5803 31.0161 39.1628 -18.0613 -25.9328 -11.5794 -9502 4 19.7424 30.2951 38.4816 -0.347779 24.7736 22.083 -9503 4 18.6224 30.9377 39.4182 28.2801 4.19594 -11.375 -9504 6 19.2561 14.7051 10.8744 35.9018 -50.5273 5.13524 -9505 4 20.0412 14.097 10.5737 -45.0165 49.548 5.48727 -9506 4 18.7602 14.0269 11.3662 -4.16951 16.5755 -2.6658 -9507 6 4.45594 39.5485 20.1375 -7.26247 21.8372 28.3356 -9508 4 3.95576 40.4005 20.2782 15.6699 -22.2203 -5.74536 -9509 4 4.87483 39.3065 21.0019 -15.4768 4.14169 -24.4646 -9510 6 29.0152 13.3442 23.91 8.01267 35.4951 15.4816 -9511 4 28.7225 12.4574 23.7464 -4.82052 -12.6612 5.31893 -9512 4 28.8407 13.5397 24.8723 9.679 -4.85246 -32.6651 -9513 6 17.068 2.76349 17.6602 17.5731 -10.7754 -19.6116 -9514 4 16.9152 3.43747 16.9733 0.569879 -2.90947 3.06519 -9515 4 17.8166 2.20316 17.3149 -21.6663 12.1671 7.12297 -9516 6 43.4725 18.0406 17.7144 -1.44781 -24.3706 15.3127 -9517 4 43.4291 17.0524 17.7495 6.1749 24.1268 -14.107 -9518 4 43.576 18.2305 18.6573 0.474252 7.4982 -2.94392 -9519 6 25.7765 40.7491 1.25834 -5.13784 -8.67992 -41.8469 -9520 4 26.3241 41.1434 1.92597 2.9618 17.1891 5.50682 -9521 4 25.7331 41.3641 0.469204 -4.81559 -13.5206 29.0343 -9522 6 0.465549 22.8917 6.22214 -2.55797 -7.94984 -3.9446 -9523 4 0.971697 22.1453 5.8424 -8.20264 3.34524 4.91565 -9524 4 1.09943 23.372 6.75946 4.60597 5.6548 -4.31438 -9525 6 26.241 35.011 18.6432 -1.36099 17.7753 -9.20742 -9526 4 25.9471 35.9461 18.6768 6.76043 -15.7179 -8.96745 -9527 4 25.6107 34.5957 19.2286 4.79325 -10.2415 3.05652 -9528 6 16.134 31.8742 7.55305 63.3701 -24.5537 -22.1036 -9529 4 16.96 31.3344 7.22221 -43.8871 18.402 28.1533 -9530 4 16.2567 32.6659 7.02685 -6.92396 6.43503 -6.66113 -9531 6 22.9365 16.8424 28.5556 -11.8911 28.7995 -6.03551 -9532 4 23.1131 16.1224 27.957 -2.92592 -13.6094 -7.1053 -9533 4 22.1672 17.3806 28.2048 22.5292 -24.3034 15.5849 -9534 6 48.8154 29.3426 32.1508 17.6607 -5.63259 25.101 -9535 4 47.9338 29.1776 31.8283 -15.752 -0.354552 -3.67809 -9536 4 48.876 28.9209 33.0523 -3.3832 13.4569 -22.7771 -9537 6 13.1275 24.861 5.55911 -24.9858 12.0714 -24.023 -9538 4 12.9095 24.1076 4.98414 3.68764 2.77663 3.09454 -9539 4 12.4428 25.5491 5.3163 19.4298 -17.0083 16.84 -9540 6 10.97 20.7168 15.838 25.2219 -21.2413 -18.4662 -9541 4 10.9273 20.4774 14.8836 -9.78471 10.8905 20.232 -9542 4 11.8407 20.3068 16.0784 -25.4832 11.5027 -0.03881 -9543 6 13.8668 18.3675 6.9377 -17.1805 34.1284 -15.5183 -9544 4 13.9861 19.3268 7.07801 0.95534 -8.68107 -9.41428 -9545 4 14.2312 17.9937 7.71618 14.696 -22.4056 21.3209 -9546 6 13.8328 12.9436 30.6366 23.8936 8.4875 1.93436 -9547 4 14.0561 12.5213 29.7889 -15.7862 -10.4805 9.2002 -9548 4 13.0857 12.5134 31.0734 -5.46762 -5.09599 -12.1481 -9549 6 17.1276 6.33232 31.2677 66.6528 76.8842 26.6004 -9550 4 16.7194 7.19542 31.0916 2.25558 -4.54354 -1.53399 -9551 4 16.4872 5.75051 31.0533 -74.7845 -70.3194 -26.0669 -9552 6 7.63688 23.4278 20.549 2.87884 3.81634 -6.68902 -9553 4 7.34623 23.1229 19.6666 2.94756 -0.449201 10.6329 -9554 4 8.04096 24.3016 20.3852 -3.87648 -11.4978 -1.95405 -9555 6 15.5875 36.6622 25.6317 44.8659 35.0544 -6.16252 -9556 4 16.5723 36.6215 25.7443 -25.3852 -14.6967 7.558 -9557 4 15.5456 37.5452 25.2115 -8.92727 -11.7797 -1.50769 -9558 6 0.738994 10.4213 22.1809 -27.1543 -36.2471 -13.1925 -9559 4 0.031346 10.3136 21.4752 22.4259 7.4169 21.1377 -9560 4 0.614162 9.62536 22.7539 0.837437 23.266 -16.3015 -9561 6 33.4753 17.3986 33.5966 50.0322 34.9653 -25.691 -9562 4 33.729 18.3684 33.3861 -23.79 -42.9591 12.1009 -9563 4 34.1104 16.8695 33.0603 -9.99519 5.32569 13.787 -9564 6 21.6594 19.0069 20.7632 22.9673 -17.6764 -6.78691 -9565 4 22.3468 19.6741 20.9606 -3.94962 -13.1079 -1.95693 -9566 4 22.1476 18.14 20.6003 -16.6978 33.0759 6.74927 -9567 6 41.7633 20.003 16.8748 -11.326 -1.31128 -8.84591 -9568 4 42.2034 19.1563 16.9874 6.48398 -7.2756 0.328325 -9569 4 41.4682 20.0367 15.9399 8.87316 5.12137 10.7952 -9570 6 12.0358 14.9766 17.6999 -26.21 -7.2152 -26.0517 -9571 4 11.2991 14.5498 17.1995 11.2858 13.8526 14.1879 -9572 4 12.4764 14.2447 18.105 9.10187 -13.3837 13.9354 -9573 6 23.0147 11.4211 40.7142 -19.9953 11.3897 74.5259 -9574 4 22.9359 12.2968 41.1901 4.60696 -23.5555 -21.1396 -9575 4 23.3157 11.5565 39.857 19.7433 14.0142 -51.5111 -9576 6 21.0056 28.3023 24.5803 -69.1041 85.2373 -40.9106 -9577 4 20.265 28.1264 25.1705 5.37048 -3.26467 3.49678 -9578 4 21.6928 27.7549 24.7451 59.1792 -66.0576 27.8401 -9579 6 19.39 13.7159 31.9239 29.4118 -13.0288 15.1298 -9580 4 18.7661 13.9847 31.2678 -13.3276 3.02657 -9.68553 -9581 4 18.8827 13.5849 32.728 -3.24577 4.6437 7.00982 -9582 6 21.5915 2.84466 24.7134 0.208747 24.5944 -29.04 -9583 4 21.6872 3.18692 23.7998 -4.92058 -5.74628 13.5023 -9584 4 22.4885 2.58061 24.905 3.18231 -12.543 15.1704 -9585 6 11.3458 29.9955 18.8336 12.03 22.8495 18.6886 -9586 4 10.5716 30.5896 18.8018 6.29595 -15.7791 -4.99952 -9587 4 11.9743 30.476 19.4324 -17.0963 -23.9187 -22.0967 -9588 6 14.6495 22.3648 8.3568 42.8177 1.00499 7.23029 -9589 4 14.0031 23.0587 8.53935 2.83958 6.20927 5.13977 -9590 4 15.5993 22.7606 8.33857 -60.0645 -13.0658 0.526795 -9591 6 43.9468 23.6541 17.2812 -2.43742 26.8438 -12.7514 -9592 4 44.7651 23.2701 16.9945 19.1668 -3.91001 -9.18188 -9593 4 43.5028 22.9 17.6346 -11.2125 -8.13016 15.2757 -9594 6 28.0047 25.4978 27.5091 9.49546 -35.4414 -7.32855 -9595 4 27.536 26.3032 27.53 -22.6173 33.7003 2.08289 -9596 4 28.9082 25.7508 27.3241 10.2254 5.98924 0.98151 -9597 6 19.1021 26.8113 33.1456 6.96794 1.44941 -44.6281 -9598 4 19.0009 26.3889 32.2316 6.61058 22.4795 36.193 -9599 4 19.4537 27.7357 32.9996 -8.5054 -25.835 6.12407 -9600 6 6.37601 19.3499 5.67113 -3.07724 -15.511 8.20386 -9601 4 6.68786 20.0294 5.07731 7.18653 8.65774 -7.7972 -9602 4 5.56195 19.7092 6.03854 -2.87224 2.62267 4.46635 -9603 6 37.49 28.403 9.68405 -10.2736 -31.6176 -26.4717 -9604 4 37.8518 27.9475 10.4351 5.1765 10.0485 19.5132 -9605 4 37.3493 27.6251 9.09625 -2.69325 25.3221 7.01666 -9606 6 17.6998 27.0953 11.7898 -36.7906 -34.4972 13.5582 -9607 4 17.0141 26.488 11.3694 25.6316 27.0728 3.78529 -9608 4 17.4298 27.07 12.7376 6.94557 14.4563 -18.9236 -9609 6 12.8888 1.93962 24.1529 -50.3802 38.9184 -15.728 -9610 4 12.0235 2.45928 24.1313 32.0413 -19.6529 -17.3906 -9611 4 12.9222 1.7892 25.0724 13.055 -19.4335 33.1456 -9612 6 27.8476 37.1183 33.3015 17.2618 -5.56645 -20.6455 -9613 4 27.8725 37.7306 32.5366 -3.66202 -8.07766 15.1749 -9614 4 28.4268 36.3488 33.0405 -13.8477 22.6944 8.61763 -9615 6 18.6736 12.3707 6.31908 6.91225 -31.4632 27.4828 -9616 4 18.6995 11.385 6.25383 -9.67628 20.7874 -2.26223 -9617 4 18.5836 12.6888 5.4344 -4.12511 6.2973 -26.1687 -9618 6 10.1784 29.305 24.7735 -9.10204 -23.9111 21.4033 -9619 4 10.6991 28.9855 25.5395 2.35147 16.2142 -6.30056 -9620 4 9.48939 28.598 24.7147 15.6456 22.7499 -9.47694 -9621 6 7.25796 3.28933 16.2737 -3.06701 21.6066 -7.53298 -9622 4 7.8017 4.02386 16.6541 -5.18893 -18.6288 5.77884 -9623 4 6.83195 2.7267 16.9458 19.6595 6.39335 -0.783342 -9624 6 32.1965 37.5589 1.11244 17.7564 -13.393 -49.4834 -9625 4 31.8113 36.9118 1.6863 -14.8068 -2.94474 23.9511 -9626 4 32.3136 38.4192 1.49585 -8.3749 16.0852 25.1081 -9627 6 10.4319 10.1504 6.4166 -7.63199 8.14139 10.6713 -9628 4 9.50403 10.3698 6.52583 -9.38347 6.87647 -8.77798 -9629 4 10.8186 10.5343 7.22249 5.92406 -9.68277 -8.25616 -9630 6 16.1813 23.2506 37.3799 25.1097 11.6639 -4.85114 -9631 4 16.5396 23.4181 38.2693 -7.5274 5.30939 -3.10176 -9632 4 16.7237 23.8262 36.781 -18.6662 -9.83464 11.0165 -9633 6 24.0859 14.3313 36.5421 -9.86516 7.30801 -0.382215 -9634 4 25.0278 14.1902 36.5644 12.4097 -8.07045 3.76472 -9635 4 23.7255 13.9571 37.3615 2.98939 6.5027 1.55174 -9636 6 27.4763 18.5532 28.7891 -13.5271 -4.91773 7.22809 -9637 4 27.279 18.1935 29.6763 -0.617381 3.48163 -16.8994 -9638 4 26.6639 18.4733 28.2428 3.34183 3.33207 10.806 -9639 6 51.5601 10.4909 1.56577 -57.9967 -14.5533 -18.7957 -9640 4 50.8004 9.99697 1.98849 19.2905 21.9947 -18.6033 -9641 4 52.233 10.462 2.20044 35.6887 -2.31897 35.1783 -9642 6 31.1159 39.6224 27.5035 10.1927 26.9633 6.19817 -9643 4 30.6636 39.3812 28.2975 -12.6206 -22.2416 8.82104 -9644 4 31.2642 40.5609 27.7597 6.49383 -23.2522 -24.0775 -9645 6 6.91312 35.9708 14.3252 -31.0555 -15.8542 22.3873 -9646 4 7.60399 36.2341 13.7609 26.7748 16.1612 -20.4248 -9647 4 7.14109 35.0698 14.5861 -2.88708 -0.858877 1.78829 -9648 6 45.5543 7.568 29.1737 -25.5302 -4.16762 -2.13202 -9649 4 44.8976 7.53234 28.4293 19.2773 0.699039 20.3251 -9650 4 45.0852 7.16669 29.9393 6.23602 2.26061 -10.7804 -9651 6 31.3622 20.562 31.6184 9.65463 4.63597 0.319717 -9652 4 31.8498 21.4034 31.7895 1.14978 -23.5084 -11.6884 -9653 4 31.8627 19.9392 31.0494 0.180852 16.2895 10.8054 -9654 6 43.0328 31.1512 10.3804 -22.1718 15.2565 33.5805 -9655 4 42.075 30.8844 10.4741 26.7443 4.92622 -3.29861 -9656 4 43.2631 31.5811 11.2548 -4.68507 -19.1463 -31.4268 -9657 6 50.935 25.5526 12.6381 -53.0362 -11.2381 37.5759 -9658 4 50.8444 26.3707 12.1889 6.26198 32.0523 -21.5557 -9659 4 51.7606 25.1556 12.4927 46.8244 -9.35474 -8.90879 -9660 6 29.329 2.97736 3.64421 22.5456 -43.1143 -6.52899 -9661 4 29.5843 3.84773 3.82541 15.3974 46.6652 11.4603 -9662 4 28.3975 3.01514 3.57252 -35.3193 1.84796 -10.7817 -9663 6 53.9306 32.0952 20.3602 -26.044 3.42844 6.98601 -9664 4 54.8587 32.2554 20.2589 13.6369 -3.90514 -8.57062 -9665 4 53.586 31.7345 19.5218 3.48091 2.50952 8.05406 -9666 6 41.7156 29.5544 6.48768 19.5894 27.0766 -19.1548 -9667 4 40.8143 29.536 6.19581 -21.1406 0.0261655 0.681639 -9668 4 42.121 30.2839 5.93213 -7.9284 -21.0777 21.5612 -9669 6 37.8354 24.5725 39.3073 -0.786614 -2.83003 -8.48557 -9670 4 37.3057 24.1981 38.5867 -0.305281 2.91934 11.1175 -9671 4 37.4479 24.2715 40.1417 -1.64355 1.86967 -5.36783 -9672 6 46.558 27.5785 23.289 -39.9634 -64.6481 11.0379 -9673 4 46.4646 27.3918 24.2576 6.74558 16.0433 -18.2165 -9674 4 45.9199 26.8188 22.9475 37.5572 46.869 6.09964 -9675 6 9.22773 27.2022 8.33468 -36.26 12.7871 28.7267 -9676 4 8.91275 27.6129 9.1801 5.62558 -9.89589 -23.2096 -9677 4 10.1414 27.0456 8.46037 35.2783 -3.07459 2.5747 -9678 6 36.0491 34.1608 13.9867 7.26402 -14.0442 8.68546 -9679 4 35.9913 33.1738 14.0461 -7.39622 22.1346 -4.41017 -9680 4 36.7548 34.3393 13.3524 -0.0889916 -4.95725 -2.25698 -9681 6 51.6742 14.4867 12.321 25.1613 25.5512 -24.4042 -9682 4 52.0989 14.4284 11.4335 -6.19684 -3.38259 22.4379 -9683 4 51.9807 15.3554 12.6493 -12.3863 -19.4348 1.31199 -9684 6 15.2583 19.6409 32.4144 29.0083 -20.2623 -33.8133 -9685 4 15.2558 19.2688 31.4922 3.04968 7.12699 22.6875 -9686 4 14.3622 19.8256 32.5802 -41.1763 4.86179 8.56209 -9687 6 27.6812 24.6569 38.3606 -19.0318 -31.8029 -32.3422 -9688 4 27.9736 25.1472 39.0974 14.6808 26.4307 29.745 -9689 4 28.3717 24.6185 37.6939 9.13491 6.22605 4.36089 -9690 6 37.5205 9.26898 13.6241 11.458 -4.07639 -2.41324 -9691 4 37.986 8.73412 14.2818 -4.17908 -1.66932 4.91722 -9692 4 37.422 10.1332 14.0472 -5.80925 -1.58022 -1.38856 -9693 6 20.8962 33.2419 26.2614 5.37543 12.855 -2.41316 -9694 4 21.3204 33.4412 27.1125 -5.30181 -3.15861 -4.46659 -9695 4 20.9369 32.3076 26.1263 8.87353 -20.0108 1.20924 -9696 6 6.59104 13.9455 35.2329 -26.8274 -4.60486 4.58094 -9697 4 6.38745 12.9897 35.2457 11.7642 5.99643 -3.17645 -9698 4 7.53507 14.0926 35.2395 12.5421 -8.77428 2.26249 -9699 6 10.0726 7.48467 6.8792 2.12641 6.95589 -11.9404 -9700 4 9.21804 7.15917 6.5645 -4.80657 -1.75614 5.47812 -9701 4 10.1222 8.42177 6.5916 5.16955 -15.159 7.51812 -9702 6 31.1977 5.95154 11.4339 24.7603 28.3677 15.6689 -9703 4 31.4296 6.16733 12.4018 -4.97657 -8.97631 -41.3224 -9704 4 31.9131 6.32779 10.8565 -11.9651 -11.6794 24.5691 -9705 6 12.1328 3.85103 35.2933 -10.0815 -12.0493 27.5499 -9706 4 12.7851 4.21657 34.7189 20.4312 8.87509 -12.0205 -9707 4 12.5123 3.89786 36.1903 -2.36263 6.36147 -16.6701 -9708 6 5.35168 6.07805 27.6549 3.96089 -18.0524 46.6648 -9709 4 5.01336 6.85569 28.0965 2.16186 8.49085 15.9688 -9710 4 5.1377 6.25223 26.7855 -7.5711 11.2001 -66.4514 -9711 6 13.1382 33.574 1.68419 20.6109 34.6607 2.95503 -9712 4 12.5953 33.0967 1.0817 -13.6453 -8.09858 -18.4215 -9713 4 13.3822 34.4502 1.26439 -11.0211 -27.5174 16.1165 -9714 6 44.6427 10.3996 29.0359 8.91116 23.4714 -13.18 -9715 4 44.4953 9.45294 29.0952 0.434286 -4.87704 -7.20081 -9716 4 44.1618 10.7755 28.2587 -0.00111917 -13.6507 16.636 -9717 6 9.15295 24.5944 6.37753 4.35763 15.0755 22.3214 -9718 4 8.87327 24.2546 5.53613 0.42871 5.14079 -20.2862 -9719 4 9.64462 25.4438 6.24707 -3.48643 -17.4971 -5.55606 -9720 6 52.5676 27.2719 21.6547 -2.39965 -30.061 -11.5856 -9721 4 52.5233 26.307 21.7841 0.332471 11.3908 13.792 -9722 4 52.7558 27.2791 20.7178 5.02488 16.4903 -8.77251 -9723 6 7.3066 16.9604 33.5537 -1.04195 2.49046 -7.43677 -9724 4 7.33543 17.7138 32.943 1.81348 -0.803559 0.920864 -9725 4 6.38938 16.6816 33.595 -7.62852 -0.129201 -7.36731 -9726 6 43.922 25.2186 7.97522 -0.776236 -10.551 19.3716 -9727 4 43.2647 24.8119 8.58447 10.2741 2.86697 -16.6436 -9728 4 43.4353 25.9147 7.53069 -5.46224 6.25576 -5.43654 -9729 6 2.0869 27.1165 13.6049 -6.62274 17.6596 -9.16822 -9730 4 2.19606 26.2295 13.9488 0.235583 -10.4047 3.43352 -9731 4 2.56841 27.1544 12.7597 2.10867 -4.70259 8.20201 -9732 6 37.3318 18.2771 2.1863 -11.4974 3.81579 3.71073 -9733 4 37.5653 17.6745 1.47223 -1.7687 -9.97531 1.83125 -9734 4 36.746 18.9091 1.7765 -5.93566 5.03593 -3.95155 -9735 6 24.9999 10.057 0.434977 -12.0635 -2.74649 0.799886 -9736 4 24.3308 10.4048 41.7106 3.78591 -9.33137 12.164 -9737 4 24.5954 9.37599 1.02184 5.69483 17.6459 -16.041 -ITEM: TIMESTEP -10 -ITEM: NUMBER OF ATOMS -9737 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 5.4990000000000002e+01 -0.0000000000000000e+00 4.1909999999999997e+01 -0.0000000000000000e+00 4.1909999999999997e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 9.97007 5.59928 0.0158605 6.82717 25.1566 0.173859 -2 2 9.62356 5.56404 40.5109 2.42388 15.8202 -17.9785 -3 2 8.17494 6.05177 40.4142 55.7411 37.9916 -4.02595 -4 3 7.24177 5.30408 40.552 -31.6102 -16.3698 1.50252 -5 4 9.18703 5.26911 0.576869 6.09491 -0.0281501 2.37507 -6 4 10.258 6.55078 0.333037 -13.6694 -25.1619 -9.93433 -7 4 10.7495 5.00053 0.227298 4.73684 -5.2578 1.97242 -8 4 10.3453 6.24708 39.9044 -16.4644 -11.4072 20.4818 -9 2 9.76873 4.13927 39.9675 -11.4588 -40.6165 34.779 -10 2 9.50273 3.78744 38.4932 15.666 28.6261 8.68394 -11 5 10.1133 2.12508 38.0108 0.295651 13.5297 3.11239 -12 2 9.21855 1.10832 39.2168 14.7368 7.58368 -1.20954 -13 4 9.08721 3.4839 40.6484 10.5431 15.7462 -21.5186 -14 4 10.7894 3.80905 40.2705 3.27862 -1.66199 -9.78219 -15 4 9.96352 4.6291 37.9056 6.4614 -19.967 -0.497951 -16 4 8.45197 3.92389 38.2658 -20.9649 -8.28542 -1.62155 -17 4 9.45855 1.42591 40.2577 0.123087 -4.74543 -3.47868 -18 4 9.48787 0.0601841 39.0477 5.23249 -11.9374 1.58081 -19 4 8.1518 1.18086 39.043 -21.148 5.31153 -2.14239 -20 1 8.09229 7.41048 40.3029 -14.2332 10.7223 -5.89196 -21 2 6.79937 8.10304 40.1889 5.24089 -19.8495 27.4218 -22 2 6.18195 7.49232 38.9365 0.114954 6.75236 -38.7125 -23 3 6.7427 7.67352 37.8124 -12.8129 -5.94191 21.2876 -24 4 8.91546 8.03754 40.1502 -4.33809 -15.705 2.93584 -25 4 6.18636 7.83053 41.1247 8.71228 4.86543 -21.2479 -26 2 7.05427 9.64124 40.1755 -39.1485 4.05492 14.7867 -27 2 5.78354 10.5475 40.1236 1.30256 17.7056 10.1762 -28 2 4.88546 10.5193 38.8862 -3.79578 -25.0164 33.8013 -29 3 5.09523 11.2746 37.9701 4.75276 20.2207 -26.2166 -30 1 3.8145 9.69296 38.9578 -10.6259 3.8922 -22.0733 -31 4 7.59986 9.93872 39.279 22.1314 0.316188 -7.87442 -32 4 7.59095 9.90263 41.1476 2.09094 2.02455 -19.3111 -33 4 6.10317 11.6308 40.2015 3.5236 -15.0099 -9.27626 -34 4 5.16114 10.4864 41.0336 -3.30627 -13.4665 3.57605 -35 4 3.54863 9.07856 39.7488 8.69916 3.95403 -0.745788 -36 4 3.18874 9.68238 38.1158 12.5738 1.24403 17.0425 -37 1 5.02604 6.79083 39.0278 7.4524 -0.797845 -45.9123 -38 2 4.17847 6.29332 37.9221 -3.7942 -15.2224 -3.95324 -39 2 2.69747 6.67222 38.2029 32.4064 16.6491 21.8024 -40 3 2.47317 7.27763 39.2627 -13.9875 -5.03172 -5.20453 -41 4 4.49693 6.75941 39.8611 -16.5463 3.77927 46.4214 -42 4 4.45927 6.7815 36.9606 1.68834 7.22657 1.16434 -43 2 4.32357 4.73766 37.6872 -14.444 16.6417 -7.09057 -44 2 3.62009 3.87951 38.7772 14.6644 -34.8859 1.43809 -45 2 5.79989 4.34797 37.5209 14.6689 -37.6664 -23.8861 -46 2 3.73665 2.34984 38.4383 -15.0607 27.3941 -9.62179 -47 4 3.8042 4.58537 36.6865 5.44811 -8.07725 9.84866 -48 4 2.54132 4.09064 38.8487 -7.82462 7.38089 1.0406 -49 4 4.05844 4.00808 39.8052 -1.99007 7.91776 -7.51683 -50 4 6.34139 4.39198 38.494 2.7915 9.59572 -3.8015 -51 4 6.26587 4.94741 36.6895 -0.816692 -0.0793993 15.4171 -52 4 5.96503 3.2496 37.1567 -11.5696 29.092 9.48874 -53 4 3.39623 2.18998 37.357 4.41378 -5.40883 18.8177 -54 4 3.12239 1.76276 39.1489 -5.35757 -4.6989 -2.16583 -55 4 4.76682 2.00075 38.5743 10.6291 -5.64517 -2.52342 -56 1 1.71265 6.3536 37.3575 -33.5913 -12.5481 -9.77554 -57 2 0.284755 6.62158 37.6816 12.6554 33.7668 -4.20076 -58 2 54.3822 5.43344 37.3699 -27.7691 3.87457 8.29319 -59 3 54.7838 4.49252 36.6867 3.01204 -3.04336 -3.37779 -60 4 1.82497 5.72672 36.5372 4.10411 3.68048 5.38879 -61 4 0.194803 6.88576 38.7694 2.48378 -12.979 2.09758 -62 2 54.7189 7.90551 36.9466 -7.72609 -12.13 5.61678 -63 2 0.656639 9.069 36.6919 -2.01357 8.03554 13.9604 -64 2 1.52683 9.2194 35.5966 7.55435 5.75852 -14.6577 -65 2 0.515029 10.1503 37.577 28.0972 23.5099 -14.6501 -66 2 2.25128 10.4257 35.3726 -4.96866 -39.5758 -10.6477 -67 2 1.27413 11.3326 37.3973 2.53894 16.486 1.64204 -68 2 2.1477 11.4375 36.2812 10.2448 65.1187 39.3263 -69 4 53.8018 8.25583 37.5371 13.1335 -2.90056 -11.9634 -70 4 54.3208 7.62968 35.9579 -2.73912 -6.0948 -8.85904 -71 4 1.62786 8.40831 34.848 -1.08621 1.70246 3.68663 -72 4 54.8519 10.113 38.4282 -15.3846 -1.92761 17.9785 -73 4 2.932 10.5406 34.5118 -0.192368 -3.19302 0.526177 -74 4 1.1987 12.2443 38.1226 0.692592 -32.2473 -20.0357 -75 4 2.79857 12.4271 36.2097 -23.9561 -41.0367 -3.09354 -76 1 53.0712 5.5328 37.7893 -5.57771 32.7805 23.2413 -77 2 51.973 4.62909 37.5111 5.69369 -27.8287 -42.174 -78 2 50.7933 5.44178 36.9635 6.83138 2.9595 14.8019 -79 3 50.2601 6.28483 37.7029 -2.00888 -3.43203 -15.9694 -80 4 52.7232 6.34215 38.4237 19.8206 -30.3225 -23.0649 -81 4 52.294 3.8899 36.6472 -5.7065 17.91 27.0613 -82 2 51.558 3.79481 38.7755 -4.51595 7.33433 1.21121 -83 2 50.3828 2.83682 38.5018 -9.13901 -44.4412 -29.5986 -84 2 52.8166 3.00155 39.2294 -15.7012 -7.04664 11.9409 -85 4 51.1774 4.47766 39.5861 12.1653 -0.853429 -2.8896 -86 4 50.5215 2.15128 37.5875 8.57056 17.9281 16.1392 -87 4 49.4053 3.30815 38.2892 0.50336 12.9055 3.57196 -88 4 50.1645 2.10956 39.3273 7.20165 10.7054 2.61524 -89 4 53.3305 3.56036 40.0335 2.85201 1.25263 3.90533 -90 4 53.556 2.88446 38.4204 4.77396 -6.45058 -3.13498 -91 4 52.5519 1.98529 39.6413 5.25091 8.27159 -2.68354 -92 1 50.4114 5.20625 35.6841 -20.1476 8.87025 -3.50293 -93 2 49.1688 5.73971 35.0966 -28.9774 8.99335 -1.66554 -94 2 48.0726 4.67952 35.3573 13.5632 -27.7837 -20.7653 -95 3 48.2724 3.51151 34.9309 -12.9152 20.0019 12.3092 -96 4 50.758 4.377 35.1895 1.67728 -2.63512 -1.50997 -97 4 48.8371 6.69602 35.5973 10.748 -7.18216 5.66994 -98 2 49.2038 6.04752 33.5367 10.0422 21.5226 29.5984 -99 2 47.9776 6.84135 32.9981 5.60977 17.6728 -19.5296 -100 2 48.06 7.31101 31.4919 41.3779 8.51018 8.58065 -101 2 48.2223 6.22581 30.3803 10.2277 10.7815 -8.37061 -102 1 48.1882 6.76889 29.0124 -44.0668 -20.3552 -6.98541 -103 4 49.2392 5.11894 32.9842 10.5057 -23.1259 -12.3022 -104 4 50.1653 6.62923 33.3927 -11.345 -5.02104 -10.4632 -105 4 47.825 7.77207 33.6051 2.48464 -5.23088 2.05035 -106 4 47.0343 6.2773 33.0942 -1.95432 -7.79908 6.21428 -107 4 48.9189 8.07819 31.4105 -13.7973 -19.6161 -0.159439 -108 4 47.1832 7.92091 31.2683 -17.7289 5.61577 -2.96622 -109 4 47.3306 5.536 30.4593 16.0468 -5.76301 1.4082 -110 4 49.2642 5.74618 30.4425 -24.8663 -4.45667 9.08666 -111 4 48.9827 7.28362 28.7526 29.3958 17.558 -6.10605 -112 4 47.3901 7.43056 28.8463 17.4375 -26.0151 1.0329 -113 4 48.1308 5.99149 28.2967 -4.23626 26.2635 18.8845 -114 1 46.923 5.03715 35.9679 -17.5656 23.7329 15.0201 -115 2 45.6707 4.26397 36.0383 7.41887 0.1342 36.2715 -116 2 44.9083 4.3955 34.7419 -9.99807 18.7078 -56.0122 -117 3 45.3082 5.1515 33.8118 -11.5681 -21.3087 27.1246 -118 4 46.8218 5.98238 36.4144 8.23522 -16.4135 -11.8728 -119 4 45.8989 3.17264 36.1884 2.80321 2.94058 -5.13324 -120 2 44.7401 4.70263 37.2808 -1.60464 -36.3649 -20.2774 -121 3 44.4616 6.07663 37.208 27.8602 32.4116 16.0792 -122 2 45.244 4.25605 38.6868 21.6281 49.2853 -20.5016 -123 4 43.7497 4.17807 37.1099 13.0537 7.54308 5.65065 -124 4 45.2592 6.57873 37.5303 -28.9412 -17.1189 -11.5145 -125 4 45.9129 5.11546 39.1089 -19.7485 -23.953 -1.10378 -126 4 45.8752 3.36487 38.6536 3.71139 -12.8851 -1.61893 -127 4 44.3595 4.03827 39.3021 -3.33201 1.23649 16.0156 -128 1 43.7613 3.66416 34.5997 13.2589 -16.0433 44.4251 -129 2 42.7828 3.62815 33.5465 18.9204 -1.21878 -42.6601 -130 2 41.7763 4.78741 33.7016 8.26701 -3.22526 52.4496 -131 3 41.2647 5.35582 32.7525 -2.05798 3.57411 -28.7638 -132 4 43.4932 3.04471 35.4154 4.99312 14.665 -20.8764 -133 4 43.36 3.79542 32.5266 -17.2288 -0.741434 30.8189 -134 2 42.0901 2.2209 33.4572 -3.06831 -30.079 -8.91003 -135 2 42.9343 0.899345 33.7586 6.86735 -2.69949 -8.81151 -136 2 42.2038 41.463 33.3849 1.50493 16.9918 14.9247 -137 2 44.2499 0.864187 32.9361 47.2855 12.5868 41.6398 -138 4 41.5678 2.05281 32.481 6.79941 12.0418 -2.16148 -139 4 41.2531 2.16469 34.1657 -6.29243 10.0771 8.19014 -140 4 43.198 0.869694 34.8519 -1.4112 0.953999 -4.44245 -141 4 42.8702 40.5903 33.6002 -4.10478 0.398246 -9.68788 -142 4 41.7896 41.4589 32.3582 7.27854 -3.68783 -7.38435 -143 4 41.3262 41.3063 34.0224 -6.75638 1.39507 6.42691 -144 4 44.0947 0.829251 31.8728 -5.75954 4.64229 -28.5029 -145 4 44.9396 41.8855 33.1737 -20.9549 12.1515 -1.19165 -146 4 44.9309 1.76601 33.2059 -22.5069 -20.3291 -10.4095 -147 1 41.5145 5.2236 34.9901 10.2672 4.08625 -51.0356 -148 2 40.6676 6.35891 35.268 -24.1778 -10.7223 -7.79527 -149 2 41.3691 7.72376 35.0974 2.95483 13.7574 -3.11119 -150 3 40.6975 8.75349 34.8431 -2.15612 -12.5202 3.44484 -151 4 41.8176 4.64617 35.7553 2.04542 -7.36824 24.1106 -152 4 39.8621 6.3427 34.4551 10.5786 9.41727 7.44594 -153 2 39.8405 6.1283 36.5756 19.8539 -2.67173 26.8296 -154 3 40.7601 5.89106 37.6735 -0.128972 20.3018 -14.678 -155 2 38.9248 4.89402 36.5497 -24.3083 -6.19306 -11.8519 -156 4 39.228 7.01129 36.8511 -0.372961 8.24506 -6.20484 -157 4 41.1549 6.75425 37.8536 -4.13097 -9.7211 -3.01543 -158 4 38.1722 4.94482 35.71 1.05658 9.14576 13.4136 -159 4 38.3953 4.71355 37.5213 -1.28546 9.2328 -6.30902 -160 4 39.3771 3.92967 36.3433 23.1336 -11.0543 -1.24287 -161 1 42.7302 7.8059 35.1562 3.49276 1.34371 4.78693 -162 2 43.5269 8.99303 34.9539 -8.19772 -21.7996 13.9087 -163 2 44.4646 9.39471 36.0778 41.0762 49.5413 -62.5687 -164 3 45.3993 10.2183 35.7654 -29.643 -36.0587 21.7786 -165 4 43.357 7.05719 35.4614 -7.13629 -15.5308 5.06399 -166 4 44.0803 8.92821 34.0189 14.2015 -9.60403 -10.8131 -167 4 42.9032 9.83742 34.7399 -16.6431 23.0824 1.78637 -168 1 44.28 8.95267 37.3076 -5.41717 -6.01048 56.4016 -169 2 45.1954 9.30059 38.3934 14.0544 9.09198 9.45122 -170 2 46.5736 8.71838 38.034 -4.40481 25.0392 4.24124 -171 3 46.7239 7.52665 37.7592 -2.06685 -10.8071 -7.31186 -172 4 43.4369 8.46722 37.66 -0.808029 1.80219 -13.797 -173 4 45.2932 10.4319 38.4595 -5.35026 -12.3633 -15.6489 -174 2 44.7775 8.83735 39.8303 19.1756 -23.9015 -7.23155 -175 2 45.4882 9.63492 40.9425 5.24315 -15.5914 27.8506 -176 2 45.0424 11.1143 41.0465 6.36216 -11.291 -10.339 -177 2 45.9827 11.9035 0.041605 38.3537 -2.96327 34.4916 -178 1 45.5586 13.2421 0.396463 -0.785075 15.3756 28.9492 -179 4 44.9912 7.72238 39.9953 -4.79728 17.8629 -7.78445 -180 4 43.7049 8.96345 39.9422 -22.2512 0.44531 4.07292 -181 4 46.5908 9.56019 40.8161 0.364544 3.82252 -6.52459 -182 4 45.3434 9.10335 0.0599805 -5.24686 13.9981 -23.7842 -183 4 44.0132 11.1324 41.4274 -10.2695 3.39123 6.70816 -184 4 44.9981 11.6023 40.04 1.8072 0.416607 6.15726 -185 4 47.0442 11.9436 41.5493 -17.6115 6.73335 -5.13538 -186 4 46.1824 11.4052 1.05233 -16.0491 -0.928483 -18.7699 -187 4 45.666 13.9003 41.5429 -6.15709 2.25656 -0.794581 -188 4 46.187 13.6261 1.17403 -31.6799 -14.737 -27.4943 -189 4 44.5482 13.2658 0.707841 33.0262 6.71149 -7.77427 -190 1 47.5786 9.61919 37.9975 -0.262725 18.6124 2.96873 -191 2 48.9681 9.33197 37.6414 -20.2336 1.72319 -17.1083 -192 2 49.7588 9.70622 38.88 39.5209 -76.7499 14.8721 -193 3 49.6145 10.763 39.4317 -9.44289 38.5374 13.5639 -194 4 47.4009 10.6083 38.3248 7.77058 -18.5649 -8.96176 -195 4 49.0172 8.23798 37.4216 9.46753 0.884559 0.506936 -196 2 49.3323 10.1282 36.3163 3.6714 0.82331 31.2642 -197 3 48.3563 9.85046 35.3281 -8.1318 -4.77519 -4.71381 -198 2 50.6865 9.72677 35.695 -19.0046 0.743943 -11.7808 -199 4 49.2557 11.2077 36.6021 8.67648 2.0602 -8.11811 -200 4 47.5419 10.2678 35.5977 -2.15846 0.170791 -0.678761 -201 4 50.8563 10.2671 34.7416 2.67544 8.24981 1.47477 -202 4 50.7066 8.66813 35.3754 2.1247 -7.47433 7.78713 -203 4 51.5309 9.954 36.3541 9.43429 -0.352141 7.40173 -204 1 50.5004 8.65755 39.48 -48.513 49.986 -45.0014 -205 2 51.0618 8.74392 40.7907 20.8089 -26.4742 28.5407 -206 2 52.5708 8.35776 40.7906 -32.7343 -31.0986 -30.3541 -207 3 52.9098 7.36002 40.1044 19.6712 31.5314 12.7437 -208 4 50.5882 7.8265 38.898 12.8881 -18.9119 10.2231 -209 4 50.9863 9.78895 41.141 -1.46865 8.60563 4.12328 -210 2 50.3037 7.79505 41.8358 -16.725 28.936 13.8764 -211 2 50.252 6.27959 41.4904 27.2589 15.6434 -4.64867 -212 2 48.8609 8.35011 0.225019 8.85004 14.588 -17.6069 -213 2 49.3953 5.42325 0.497373 -18.8945 7.05888 30.2377 -214 4 50.814 7.95159 0.918621 8.35305 -8.94958 -7.30269 -215 4 51.3186 5.93048 41.4774 -6.84536 -5.23847 5.64953 -216 4 49.9408 6.1608 40.4387 -8.33431 -3.05112 -5.55566 -217 4 48.166 7.96072 41.344 -1.46 7.63128 5.53427 -218 4 48.8165 9.51657 0.246026 0.467008 -30.2893 -0.065267 -219 4 48.5175 7.97406 1.21641 -4.07563 3.27994 -1.48455 -220 4 48.2983 5.58085 0.347667 5.50609 -0.627552 -5.84055 -221 4 49.5344 5.58322 1.60624 7.63779 5.91871 -13.4594 -222 4 49.5909 4.36583 0.361303 3.03099 -20.7712 -9.01704 -223 1 53.3669 9.15083 41.5136 39.5682 14.7354 5.79836 -224 2 54.8443 9.26777 41.6313 -32.7918 27.0996 3.53674 -225 2 0.372396 8.2907 0.722751 15.0567 -33.4937 20.6099 -226 3 54.8856 8.2259 1.87915 11.4238 -3.26125 -20.3466 -227 4 52.9167 9.73978 0.288924 -10.841 14.2188 11.5997 -228 4 0.25416 9.07559 40.636 9.98484 -5.7038 -17.1316 -229 2 0.351513 10.7152 0.19938 0.985642 14.1538 -10.6635 -230 3 54.4575 11.7797 41.7528 -11.3464 -18.6066 -9.73211 -231 2 1.66903 11.1049 41.4122 7.34382 -22.4378 -10.8926 -232 4 0.4803 10.8256 1.29559 2.15483 -15.9854 6.57991 -233 4 54.1789 12.1729 0.660397 -4.76608 7.18995 2.46446 -234 4 2.02372 12.0909 41.706 2.9877 17.6459 6.95349 -235 4 1.57896 11.139 40.2943 0.339955 -2.68366 6.65003 -236 4 2.50746 10.4017 41.6821 -7.50419 3.69742 -2.77337 -237 1 1.45709 7.55056 0.343709 0.783377 10.0466 -6.42735 -238 2 2.26763 6.65075 1.15078 -32.6055 -6.94536 -7.22798 -239 2 3.71498 6.9634 0.985171 49.9575 39.4499 -62.468 -240 3 4.16139 7.41516 41.7733 -24.7374 -20.1855 46.264 -241 4 1.86812 7.64334 41.3079 -3.10568 2.79536 2.39364 -242 4 2.02547 6.77359 2.21072 -7.15361 5.99983 10.1715 -243 2 1.97017 5.19949 0.677115 9.24237 23.8034 -8.70369 -244 2 0.525 4.76245 0.942436 -1.25511 -23.3688 27.6866 -245 2 0.292475 3.39123 0.300736 12.896 -21.1671 11.4366 -246 2 0.300138 4.59931 2.47443 -32.0383 1.7301 9.08136 -247 4 2.70003 4.54767 1.15632 6.2908 -16.3803 10.1517 -248 4 2.22696 5.13751 41.5068 -3.29253 -1.30987 -4.15087 -249 4 54.7656 5.47042 0.590489 -8.39992 14.3218 -15.0438 -250 4 54.2418 3.05018 0.328915 -13.2626 1.11831 3.00682 -251 4 0.884488 2.58096 0.823664 -4.50955 14.351 -5.98985 -252 4 0.593908 3.34298 41.1636 3.48003 3.40906 -16.1017 -253 4 0.952355 3.83641 2.92287 8.67303 -5.41594 2.10418 -254 4 54.195 4.2418 2.71744 29.7111 15.4634 -7.25797 -255 4 0.523461 5.5584 3.03176 -8.55492 -11.4476 -4.98522 -256 1 4.54724 6.69628 2.0028 -11.6083 -5.66543 -5.23244 -257 2 5.9708 6.78048 2.07185 29.6953 24.7002 11.5216 -258 2 6.62679 5.47067 2.57826 -56.9161 -25.5018 -48.7527 -259 3 7.55514 5.44421 3.3345 43.3901 -4.04961 27.9945 -260 4 4.11753 6.29088 2.82459 -1.31884 -6.15538 19.0144 -261 4 6.38329 6.99012 1.0501 -1.44469 -12.2628 1.79191 -262 2 6.4556 7.99651 2.97484 -29.1307 10.2847 -18.0571 -263 2 6.5028 9.34873 2.22705 -18.2939 24.7932 5.04877 -264 2 6.67525 10.5485 3.20576 -19.6949 -28.8822 -17.9407 -265 3 7.83409 10.9407 3.49149 14.4815 4.00472 5.8048 -266 3 5.6204 11.0576 3.67938 3.00737 1.04452 3.25275 -267 4 7.46376 7.72864 3.29072 15.5933 3.84479 14.8832 -268 4 5.82416 8.22265 3.87848 3.62309 -20.6245 -0.107855 -269 4 5.50278 9.55154 1.65377 27.7023 -9.35583 7.15892 -270 4 7.36204 9.37759 1.52673 -1.86837 -2.39822 -10.1271 -271 1 6.01547 4.32119 2.13096 24.825 18.8056 21.8908 -272 2 6.40109 2.94617 2.38906 -11.7575 -20.1643 -12.9237 -273 2 7.81521 2.61654 1.77783 -56.2322 2.45294 33.4207 -274 3 8.31478 3.35811 0.966233 17.239 19.087 -22.9985 -275 4 5.23593 4.40493 1.50032 -13.4301 6.78787 -12.4159 -276 4 6.42741 2.74871 3.48587 6.57798 6.02642 3.28221 -277 2 5.2086 2.00284 1.82478 32.9723 -19.5112 -16.552 -278 2 3.90497 2.10853 2.63909 4.11684 35.775 58.6384 -279 2 4.90372 2.28313 0.318971 -25.0993 -16.9694 6.10511 -280 4 5.56913 0.900136 1.85726 -4.66192 22.2662 6.6067 -281 4 4.03562 1.77943 3.74204 2.08752 -4.13501 -29.3045 -282 4 3.08076 1.58512 2.20328 -21.6762 -25.4002 -11.7361 -283 4 3.47043 3.14079 2.79739 15.5883 -5.24062 -11.8252 -284 4 4.40039 3.24668 0.146776 -5.79992 5.24774 -1.28692 -285 4 4.20501 1.47402 41.8336 8.41255 14.6516 3.66501 -286 4 5.77159 2.28177 41.569 16.6343 -1.64949 -4.80555 -287 1 8.4358 1.54559 2.27475 36.6082 -11.5601 -11.8896 -288 2 9.77403 1.09441 1.8307 -27.8835 12.6882 -14.7267 -289 2 9.60932 41.7912 0.904414 -8.95822 -4.80133 -2.77359 -290 3 8.60977 41.0717 1.04857 16.9017 -0.350054 -8.54673 -291 4 7.96937 0.851078 2.83344 -16.1443 -13.3321 15.6909 -292 4 10.1447 1.96102 1.23179 21.7718 -7.90657 2.9301 -293 2 10.6071 0.627222 3.03652 -0.441548 -3.06629 28.3632 -294 2 11.1182 1.69736 4.03374 -39.6019 -9.33118 23.345 -295 2 12.4276 2.26482 3.60541 40.3504 -3.80329 2.03759 -296 3 13.4833 1.65854 4.00477 -10.9735 16.3163 -6.96273 -297 3 12.4619 3.21875 2.76405 -4.75337 -1.04793 7.93588 -298 4 11.5429 0.117807 2.72279 -4.90068 -9.43781 -6.0473 -299 4 9.98495 41.7532 3.61242 16.0495 13.2539 -10.4034 -300 4 11.2741 1.17979 5.05068 -3.18835 9.28581 -16.8758 -301 4 10.3234 2.48031 4.23808 10.2695 -6.11036 -3.24845 -302 1 10.6563 41.4604 0.0588169 -6.20046 -15.666 -8.24155 -303 2 10.7096 40.1842 41.1911 4.64874 21.5238 9.65168 -304 2 10.6577 38.9638 0.161439 -6.67174 -46.3648 23.9629 -305 3 10.1435 37.8848 41.6696 11.1653 29.5239 15.2576 -306 4 9.85832 40.1011 40.5066 -14.3391 4.69386 -5.52668 -307 2 12.0141 40.2124 40.3653 4.26726 1.71904 -5.44169 -308 2 12.4668 41.6661 40.4777 -1.00635 15.6111 -33.0282 -309 2 11.8673 0.323303 41.767 -12.6506 -21.5702 -15.1443 -310 4 11.8545 39.873 39.2959 0.539662 6.91875 10.5587 -311 4 12.8304 39.5641 40.7546 -3.32338 -3.68521 7.20301 -312 4 12.0951 0.327352 39.5607 -0.26902 -6.73625 15.8499 -313 4 13.5766 41.7696 40.398 -3.05617 -0.547794 6.53436 -314 4 11.6542 1.3898 41.6565 2.06281 16.0871 1.21765 -315 4 12.5433 0.162045 0.691867 15.5992 2.8717 16.0141 -316 1 11.2193 39.0766 1.4086 -4.36655 24.7542 -22.059 -317 2 11.4309 38.0888 2.42328 2.01986 -2.25877 10.0578 -318 2 10.2357 37.7662 3.3374 -3.13249 5.62439 -12.9442 -319 3 10.4243 36.9709 4.25096 -6.41092 -9.96708 1.94465 -320 4 11.5904 40.0068 1.66465 -1.36758 -8.10945 4.45955 -321 4 11.6246 37.1209 1.91909 1.66244 -5.96089 -4.69733 -322 2 12.7089 38.4628 3.26447 -19.7243 1.96837 18.865 -323 3 12.593 39.7548 3.85012 -16.3579 -13.4437 -0.292868 -324 4 13.6002 38.4999 2.63657 13.9756 -7.10852 -11.694 -325 4 12.8962 37.7302 4.10036 -1.36843 4.44789 -10.4248 -326 4 11.9859 39.6657 4.60642 10.4094 13.6351 -5.41979 -327 1 9.02275 38.3618 3.12708 -24.8633 34.0603 -47.8229 -328 2 7.7797 38.1104 3.9237 -5.5143 -4.40103 -12.4219 -329 2 6.80948 37.1627 3.16843 27.134 16.5749 8.61656 -330 3 6.86683 37.0056 1.95165 6.52379 13.0808 -10.3152 -331 4 8.81363 38.9852 2.21874 13.7891 -35.0234 50.9651 -332 4 8.06628 37.5753 4.84119 7.22917 -10.5654 7.4735 -333 2 7.01568 39.4093 4.3407 2.69101 -11.9593 -14.7657 -334 2 7.81876 40.1019 5.42325 -6.79454 3.60365 -28.1432 -335 3 8.28496 41.241 5.20721 -2.75331 10.4655 -0.123769 -336 3 8.08719 39.4782 6.47272 0.652509 -5.2024 22.4807 -337 4 5.97814 39.1687 4.67547 5.82193 1.31451 7.85599 -338 4 6.83632 40.0167 3.42407 6.48365 7.00102 3.75656 -339 1 5.92582 36.4787 3.90047 -14.2639 -13.8348 21.4567 -340 2 4.95916 35.6178 3.24268 -4.4575 6.83929 8.3992 -341 2 3.83929 36.4769 2.71202 -44.4588 -49.3176 -48.5312 -342 3 3.60925 37.6169 3.05258 2.07424 26.7384 14.4764 -343 4 5.8145 36.534 4.942 7.63157 5.21975 -16.3776 -344 4 5.40617 35.1414 2.34351 4.65472 -4.22423 0.555341 -345 2 4.39718 34.509 4.16235 13.2774 -34.7614 9.16528 -346 3 3.98438 35.0519 5.39575 -10.4467 6.31908 32.28 -347 2 5.50619 33.4543 4.48033 -18.4692 -3.54598 29.0115 -348 4 3.53919 33.9402 3.74776 -4.47694 5.79242 -10.2957 -349 4 3.62452 34.3759 6.00064 11.5458 5.5573 -22.0279 -350 4 5.86065 32.9579 3.58801 8.19644 -6.15464 -22.9143 -351 4 5.08151 32.5761 5.12909 16.3877 29.7333 -11.6263 -352 4 6.39565 33.9521 4.95041 -3.85278 -8.84208 3.35803 -353 1 2.97294 35.7888 1.83357 24.6732 25.9217 25.2152 -354 2 1.71267 36.3687 1.37347 -5.03432 -5.896 10.5631 -355 2 0.744229 36.5497 2.58991 -5.24139 24.3125 -23.8477 -356 3 54.9871 37.5497 2.63122 18.6385 -17.0409 3.73872 -357 4 3.28773 34.8825 1.44268 -6.98273 2.93822 -0.272558 -358 4 1.87243 37.434 1.07109 4.86902 -3.5162 -5.74397 -359 2 1.111 35.5523 0.154125 -16.9781 -2.34719 28.1775 -360 2 1.71191 35.9998 40.7076 5.75717 0.931703 -28.4951 -361 2 54.5365 35.7134 0.116808 -8.16561 0.919103 1.38616 -362 2 3.27145 35.9095 40.6267 -43.0781 7.09941 -3.6072 -363 4 1.31237 34.4411 0.36052 2.96229 18.9121 -10.1464 -364 4 1.38444 37.0145 40.3207 4.07875 -5.77915 19.4423 -365 4 1.27316 35.3433 39.9124 8.37762 -5.40948 6.65521 -366 4 54.0772 35.0942 41.2103 3.74338 3.48587 4.89864 -367 4 54.2123 36.7722 41.8688 5.5832 -2.69651 -3.34762 -368 4 54.0157 35.4055 1.08169 10.5414 -0.491815 -14.4897 -369 4 3.61367 34.902 40.8802 7.83264 -12.2373 1.45006 -370 4 3.69229 36.6315 41.3343 12.2091 5.94613 6.19684 -371 4 3.59275 36.1798 39.604 6.95495 -3.49191 -4.00644 -372 1 0.74604 35.6172 3.54454 -3.3388 -35.9018 49.598 -373 2 0.0112331 35.6552 4.85892 21.257 7.22823 -39.6883 -374 2 0.198256 37.0471 5.48367 -2.86302 -31.8341 -17.2866 -375 3 54.1912 37.6952 5.75353 -1.48181 26.0574 3.92406 -376 4 1.16676 34.6739 3.4098 -0.571923 12.3969 -9.16993 -377 4 53.9399 35.5324 4.59955 -13.6683 1.62606 4.36563 -378 2 0.479844 34.4894 5.77304 -8.63544 -0.437888 22.4632 -379 2 54.7769 34.3327 7.14546 -8.87326 -9.27459 2.92058 -380 2 0.0146857 35.4787 8.12524 6.60033 -5.57439 2.5368 -381 3 54.0952 36.3427 8.3329 8.35004 -1.43527 5.86114 -382 3 1.11008 35.478 8.75909 4.47833 6.11486 1.03148 -383 4 1.57132 34.5563 5.98457 -0.698959 1.91632 -4.64924 -384 4 0.309529 33.5134 5.28188 2.4365 -3.54209 -11.468 -385 4 0.179249 33.4003 7.64738 0.479338 5.67065 -5.66203 -386 4 53.6776 34.105 7.04833 9.83525 6.91672 -4.06122 -387 1 1.48459 37.3964 5.63734 26.9411 18.0032 -4.38534 -388 2 2.00708 38.6625 6.18614 -17.3218 -26.0277 -29.9987 -389 2 1.56827 39.8885 5.33406 1.07082 -15.6319 68.2882 -390 3 1.08143 40.8395 5.94485 1.04665 3.34176 -10.6171 -391 4 2.21263 36.6994 5.39095 -3.57075 5.04293 0.958686 -392 4 1.48422 38.7142 7.17744 15.2971 12.5748 0.959573 -393 2 3.55969 38.5843 6.25222 7.32448 -15.8569 15.0135 -394 2 4.09689 39.7132 7.09894 -5.63198 1.92213 9.01267 -395 3 4.56636 40.7179 6.56654 0.030916 3.04529 -1.1693 -396 1 3.96361 39.556 8.43894 1.042 12.9555 16.4237 -397 4 4.05831 38.7157 5.24953 -10.2579 -5.90723 4.64011 -398 4 3.91694 37.5778 6.70114 -5.07122 23.1073 -10.2752 -399 4 3.40266 38.7698 8.86734 10.6722 14.2638 -7.23316 -400 4 4.31989 40.3411 9.06061 -10.7144 -22.9188 -14.0526 -401 1 1.60475 39.819 4.02334 -43.55 39.5967 -43.6917 -402 2 0.959151 40.8062 3.12947 9.93922 10.0651 20.657 -403 2 54.4776 41.0208 3.48285 -52.4492 -13.4217 15.5726 -404 3 53.9715 0.237442 3.65017 19.1527 -10.2385 2.60078 -405 4 2.04263 39.1125 3.49268 25.4866 -43.7222 -11.6271 -406 4 1.43469 41.7946 3.36052 -1.16639 -0.650149 -3.04645 -407 2 1.13376 40.5205 1.61049 -4.45578 -2.70165 -27.9407 -408 2 0.490261 41.6149 0.695896 4.53105 0.20202 29.6943 -409 2 2.64975 40.4484 1.23692 -3.92583 -1.39436 -18.6979 -410 4 0.60342 39.5705 1.32385 8.41785 -1.89228 7.96418 -411 4 54.3692 41.6195 0.82936 4.25856 9.6792 3.81375 -412 4 0.622371 41.4492 41.5424 7.52435 -6.48816 -19.7965 -413 4 0.973053 0.688907 0.936332 -12.1275 -4.49455 -2.44597 -414 4 2.86969 40.4983 0.122209 -12.9804 -12.5133 18.6513 -415 4 3.14027 39.5547 1.69882 2.20392 3.04031 -6.93039 -416 4 3.17994 41.3387 1.56797 8.55742 10.8937 16.8775 -417 1 53.6665 39.902 3.64569 3.02926 35.878 11.6697 -418 2 52.2466 39.9148 4.06102 19.2385 27.0707 -26.8098 -419 2 52.053 40.5369 5.44904 5.36155 -11.3244 -6.70427 -420 3 51.0493 41.2119 5.6977 3.00195 1.8183 -1.23959 -421 4 54.0359 38.9941 3.4462 12.1828 -26.316 -3.91411 -422 4 51.7731 40.6655 3.34079 -4.82064 -14.7659 11.8755 -423 2 51.582 38.5149 3.95778 -5.61462 -20.1546 -9.91009 -424 2 51.4355 37.9559 2.49174 21.0062 -12.2216 22.8132 -425 2 51.0144 36.4629 2.37849 -12.7289 -13.0945 -11.3158 -426 2 50.8009 35.9817 0.883468 22.3055 45.8074 13.5352 -427 1 50.1864 34.6873 0.684667 2.36531 28.1154 -10.556 -428 4 50.5344 38.5648 4.38466 13.3699 -2.49694 2.21203 -429 4 52.2198 37.7725 4.53757 -13.8611 9.51826 -2.20414 -430 4 52.4594 37.9738 2.01537 -10.7122 14.3169 -4.94324 -431 4 50.6781 38.6054 2.01085 7.27079 0.282464 -15.5314 -432 4 50.0599 36.3043 2.92579 -2.19776 -0.350037 2.41174 -433 4 51.7586 35.7685 2.83822 0.223715 4.6579 4.31096 -434 4 51.8274 35.9658 0.402852 -15.0801 -2.53131 0.358002 -435 4 50.2142 36.8299 0.38331 4.02889 -26.7998 -2.47013 -436 4 50.6312 33.9821 1.2741 -7.74727 -6.99272 -14.4028 -437 4 50.1255 34.5169 41.5875 17.6482 -15.4813 7.31014 -438 4 49.2229 34.7469 0.909632 -22.6621 -5.40937 19.0501 -439 1 53.014 40.2496 6.3528 -7.33511 22.7823 24.6419 -440 2 53.0995 40.7279 7.73814 -49.8191 -29.044 -3.24915 -441 2 53.1557 0.329785 7.7965 36.8238 12.814 -39.8954 -442 3 52.5287 0.997511 8.60414 -15.9304 4.02299 13.5617 -443 4 53.7341 39.5741 6.15629 12.7417 -17.108 -13.0125 -444 4 52.0658 40.401 8.2322 35.0205 13.5384 -7.46142 -445 2 54.2887 40.0362 8.44194 -31.1952 -6.28028 37.9979 -446 4 54.3393 40.3597 9.51814 11.9598 15.0179 -15.3163 -447 4 0.207826 40.1934 7.85611 17.4499 5.7482 6.56468 -448 4 54.1321 38.9464 8.61757 0.233079 -2.0185 -17.8759 -449 1 53.9798 0.938968 6.8679 -0.195991 -19.5991 -5.8991 -450 2 54.0539 2.3703 6.69095 -13.0728 33.3033 12.6105 -451 2 52.7411 3.03405 6.19669 -13.7918 -57.342 -43.9621 -452 3 52.3429 4.1409 6.51048 0.805927 21.8583 24.6591 -453 4 54.6966 0.402301 6.30051 -22.9471 7.504 14.9388 -454 4 54.1387 2.85352 7.70963 6.90446 -7.48262 -5.16091 -455 2 0.230181 2.82991 5.77971 -8.39605 37.5401 -18.7849 -456 2 1.62806 2.36187 6.13631 43.8101 -17.859 13.5365 -457 2 2.01439 2.63812 7.6434 4.44409 -15.8917 -34.667 -458 2 3.251 1.82053 8.03886 10.3698 -25.435 21.3536 -459 1 3.78609 2.13458 9.37971 -1.03569 -21.7613 -70.4054 -460 4 0.236987 4.00662 5.72725 -0.841737 -32.3075 1.88093 -461 4 55.0233 2.47547 4.72977 -1.92078 4.0191 4.58104 -462 4 2.43886 2.84427 5.52141 -13.7997 6.98566 -1.14785 -463 4 1.8001 1.26942 5.8525 -13.1218 12.7308 11.199 -464 4 1.17734 2.2629 8.25415 -4.76662 9.03037 15.6753 -465 4 2.26439 3.72233 7.77766 -11.2971 -1.006 3.39024 -466 4 4.0605 1.91272 7.29579 6.96563 5.43042 -1.59904 -467 4 3.03028 0.709673 8.06144 -4.99399 12.6268 -3.20223 -468 4 3.89697 1.2978 9.90866 2.2165 -13.9672 17.3419 -469 4 3.11983 2.70535 9.83652 -2.18207 25.7622 26.4666 -470 4 4.71792 2.51816 9.23842 -3.78155 13.4581 18.6473 -471 1 52.0021 2.30339 5.27929 12.8772 20.7449 44.6796 -472 2 50.6928 2.72834 4.84618 -13.8318 -0.832969 -24.58 -473 2 49.579 2.58092 5.91693 0.565718 25.7533 -2.22664 -474 3 48.7752 3.51298 6.10069 9.60089 -13.9081 0.0850852 -475 4 52.4111 1.47967 4.84803 3.54375 -13.752 -6.04623 -476 4 50.7183 3.81521 4.5849 2.62435 0.742467 8.46338 -477 2 50.3339 2.0499 3.47904 12.4361 -26.7668 8.24264 -478 2 51.3981 2.34325 2.36407 -25.9391 22.844 -14.5031 -479 2 48.9153 2.37958 2.98651 -2.89914 40.9383 9.35249 -480 2 51.1891 1.41918 1.15407 38.5806 -15.4927 -30.3188 -481 4 50.4158 0.92469 3.65006 -8.90797 13.02 4.48026 -482 4 52.4055 2.20648 2.74929 18.7984 -5.45377 5.09466 -483 4 51.3666 3.42411 2.00589 -1.76359 -13.5005 7.53435 -484 4 48.1353 2.36077 3.79579 2.75746 -16.6411 -10.078 -485 4 48.6799 1.76326 2.11438 -14.9792 -11.0957 -5.84075 -486 4 48.8325 3.45193 2.63807 7.50371 -11.7896 -0.401559 -487 4 52.1004 1.43799 0.414216 -21.3416 1.39174 26.2203 -488 4 50.3409 1.68288 0.503068 -10.2032 3.93981 2.99084 -489 4 51.0565 0.33979 1.46483 1.72575 11.8892 -3.22767 -490 1 49.5807 1.53255 6.75244 19.5889 -24.3514 7.76629 -491 2 48.7262 1.39688 7.92951 3.12598 20.2674 -1.73108 -492 2 48.8873 2.63773 8.86406 -22.8968 -16.6402 -5.42224 -493 3 47.8891 3.05472 9.45614 -0.472007 6.27789 -5.95623 -494 4 50.2352 0.731103 6.58688 -10.8709 15.7502 1.66713 -495 4 47.6402 1.39986 7.60999 11.2933 -0.131061 -1.07735 -496 2 49.0614 0.0990051 8.70607 -29.9824 -25.1823 -11.7347 -497 2 48.2869 41.7602 10.01 13.4599 -0.122667 29.7563 -498 2 46.7828 0.0292377 10.0132 -0.929007 -24.4408 -23.1824 -499 3 46.2118 0.52149 10.9702 -12.9016 15.2185 13.9881 -500 1 46.1401 41.3429 8.96595 27.5879 22.2376 34.4467 -501 4 50.107 0.108866 8.97457 27.7162 -1.73681 3.74735 -502 4 48.8999 41.0818 8.03917 5.36927 20.2302 10.0129 -503 4 48.7183 0.460982 10.852 -8.35522 8.57003 -12.646 -504 4 48.4869 40.755 10.454 -1.65554 -4.90235 -14.5783 -505 4 46.6392 40.8985 8.22302 16.4703 -11.2583 -22.7525 -506 4 45.1487 41.2958 8.97726 -40.9601 -1.33251 0.190018 -507 1 50.0995 3.17318 9.05078 3.95851 -0.0485648 -3.79593 -508 2 50.3325 4.25644 9.97415 17.5873 21.0859 -2.62556 -509 2 49.9752 5.63804 9.37548 -18.0954 -29.5198 29.938 -510 3 49.379 6.45094 10.0988 9.73071 -4.74536 -2.58342 -511 4 50.9107 2.76055 8.59957 11.9693 -5.38147 -4.75744 -512 4 49.6509 4.09994 10.8399 -6.9467 2.38538 1.23714 -513 2 51.7744 4.26209 10.561 -12.6039 -21.2869 -0.279481 -514 2 51.8614 5.17465 11.7883 77.4573 -1.34868 -55.222 -515 3 50.9415 5.19238 12.5756 -62.6641 4.37367 45.7089 -516 3 52.9385 5.83334 11.9521 -15.5069 -3.45829 -0.856418 -517 4 52.5513 4.49045 9.80335 -1.41111 7.91559 -3.33271 -518 4 51.9847 3.17606 10.8252 3.56611 15.7947 8.37571 -519 1 50.1134 5.83384 8.05697 5.03044 -3.38183 -24.9476 -520 2 49.6949 7.07302 7.45907 -6.39224 21.6045 -14.6025 -521 2 48.2404 7.19765 6.96855 9.41443 -40.5535 -11.5325 -522 3 47.5994 8.23003 7.09737 -2.60339 17.4007 5.13595 -523 4 50.5903 5.18529 7.39903 -4.72806 0.48988 13.3104 -524 4 49.6568 7.79446 8.28532 6.84483 14.8177 6.93296 -525 2 50.7045 7.63108 6.39006 -19.8247 -9.47824 8.02755 -526 2 50.6996 6.84785 5.08902 -10.629 2.31661 -15.1243 -527 2 51.6586 7.26626 3.9659 -11.3496 43.5825 3.95364 -528 2 53.1317 7.00105 4.2557 32.8208 18.7244 -18.8206 -529 1 53.7683 7.95578 5.14747 -10.6729 7.59108 -11.9454 -530 4 51.7028 7.64661 6.81348 16.7201 -1.45014 11.0251 -531 4 50.4708 8.68128 6.19684 -5.34256 14.1207 -5.41714 -532 4 49.6713 6.8702 4.6668 -0.861277 1.74329 -1.61352 -533 4 50.8688 5.79892 5.31654 5.28855 -19.0543 2.54637 -534 4 51.4741 8.35024 3.65396 8.42695 -12.5098 16.2485 -535 4 51.3565 6.79125 3.04708 -1.5826 -26.0582 -19.3792 -536 4 53.7673 7.0998 3.31183 -20.6632 -9.77681 9.39502 -537 4 53.2972 5.98514 4.64126 3.7215 -8.75629 2.11801 -538 4 53.3251 8.87081 5.17658 4.71004 0.103302 -2.74719 -539 4 54.7439 8.12131 4.95956 10.0262 2.1061 -7.58392 -540 4 53.7752 7.60869 6.06781 -3.05466 -8.65204 35.212 -541 1 47.7159 6.1092 6.3306 31.3529 14.3598 14.0351 -542 2 46.4076 6.11425 5.7591 -25.7668 -19.0326 -13.8071 -543 2 45.4013 5.23171 6.47844 56.1675 -11.9112 16.6864 -544 3 44.23 5.34684 6.24133 -49.2229 2.39302 -4.99484 -545 4 48.3398 5.28969 6.15889 -17.2258 10.451 -1.21207 -546 4 45.9358 7.11624 5.83656 4.3919 7.44058 4.79016 -547 2 46.401 5.6982 4.25555 12.45 -16.5042 -24.1702 -548 2 46.8608 6.82251 3.28226 -4.83626 -15.1342 -13.4955 -549 2 46.0803 8.13881 3.30599 -14.5444 -4.79224 -13.1752 -550 3 44.9716 8.27119 2.67975 10.7775 -8.64163 7.28309 -551 3 46.5691 9.08454 3.95876 4.86602 16.815 8.62941 -552 4 45.3845 5.39013 3.90204 -1.72737 6.76951 8.44594 -553 4 47.0179 4.72632 4.06618 -9.2699 26.8442 8.77601 -554 4 46.8747 6.40942 2.20799 2.04532 8.89503 18.2744 -555 4 47.9008 7.08537 3.56457 7.18737 -1.18981 -5.53646 -556 1 45.8799 4.29222 7.33829 -37.7514 2.20406 -4.61566 -557 2 44.9987 3.41141 8.06424 -3.99299 1.7641 -5.76947 -558 2 44.3276 2.33248 7.21969 -45.1266 -42.7281 27.6017 -559 3 43.411 1.613 7.73718 25.6836 24.6852 -13.962 -560 4 46.8488 4.10168 7.49502 31.0353 -1.43619 1.82022 -561 4 45.5349 2.87862 8.87403 3.80662 2.65181 2.49747 -562 4 44.2009 4.01738 8.56522 2.51171 -3.43938 -1.53795 -563 1 44.7359 2.05713 5.97006 1.92732 3.23614 21.462 -564 2 44.1948 0.978467 5.13766 -26.7101 17.135 -13.9432 -565 2 44.8486 41.5478 5.5025 3.41127 -20.6454 16.5554 -566 3 46.0871 41.4431 5.57675 -14.0525 11.0231 2.35631 -567 4 45.5581 2.59183 5.73006 15.6975 -3.64086 -27.3416 -568 4 43.0338 0.980574 5.28193 28.569 -9.56263 1.83686 -569 2 44.4255 1.37435 3.62453 6.02041 -5.1027 -4.41971 -570 2 43.5303 2.62118 3.29791 4.64703 16.7196 -23.7169 -571 2 44.2051 0.148173 2.67978 -29.1583 2.83252 11.5038 -572 2 43.5747 3.10962 1.83395 1.21002 2.08355 -6.515 -573 4 45.4937 1.66977 3.44724 -0.165314 0.952935 9.41179 -574 4 43.8006 3.52551 3.92139 -2.56937 -12.5949 1.07415 -575 4 42.4611 2.43664 3.46298 -10.2855 -9.14552 12.9963 -576 4 44.5119 0.377143 1.64896 8.27723 -0.881131 -7.54742 -577 4 43.1044 41.7625 2.59144 16.8524 3.81389 6.96191 -578 4 44.7846 41.171 3.05101 -3.46686 1.83863 -12.0461 -579 4 44.5392 3.56167 1.57116 9.55733 8.13116 4.62467 -580 4 42.7809 3.86627 1.57982 6.14378 -4.69974 7.81616 -581 4 43.4757 2.31615 1.08375 -8.22918 -11.6964 -1.57482 -582 1 44.0839 40.4233 5.76821 21.932 -1.5334 -8.86254 -583 2 44.7424 39.1674 6.24443 -3.28027 29.5462 -2.23354 -584 2 45.6232 38.4648 5.15467 16.5957 -3.17533 31.1682 -585 3 45.1655 38.1269 4.0769 -9.06079 2.14789 -9.97198 -586 4 45.3594 39.5074 7.13461 -7.15079 -15.4686 -7.49065 -587 2 43.5266 38.3049 6.70081 12.2837 2.36218 -7.01546 -588 2 42.3912 38.8204 5.83129 -5.25874 0.19697 14.2242 -589 2 42.6515 40.3318 5.90174 -25.8883 17.7161 37.6601 -590 4 43.2615 38.5482 7.76954 6.63706 -13.879 -3.94164 -591 4 43.7406 37.2122 6.50504 -6.24398 7.50926 12.4246 -592 4 41.3856 38.4747 6.1895 5.24712 7.09666 -1.13826 -593 4 42.5101 38.4102 4.83081 -0.0162975 -1.57753 -20.806 -594 4 42.2783 40.7857 6.94925 18.7272 -16.9878 -38.5107 -595 4 42.0764 40.8825 5.13323 2.00122 -0.967094 -8.03005 -596 1 46.8623 38.0021 5.57674 -15.3549 -23.0767 -9.82664 -597 2 47.7161 37.0187 4.84527 -3.88045 42.2808 23.2471 -598 2 47.0384 35.8723 4.15029 10.1677 -9.37304 -39.3599 -599 3 47.4551 35.4743 3.0324 -9.4669 19.846 29.5852 -600 4 48.2252 37.6386 4.0698 7.54977 -11.2433 -2.33648 -601 2 48.6452 36.5035 5.99482 -10.0312 13.1223 -5.95218 -602 2 48.8959 37.7819 6.80046 -4.41071 -5.72741 24.5975 -603 2 47.4918 38.4151 6.80561 23.284 1.3706 -4.72721 -604 4 49.5844 36.0861 5.59811 5.91725 -9.04521 -0.913385 -605 4 48.1158 35.748 6.64071 6.83063 -0.71303 -5.46675 -606 4 49.6383 38.4449 6.34864 7.02588 7.83512 -10.7506 -607 4 49.3019 37.5753 7.85532 -11.9914 1.76609 -18.7023 -608 4 47.544 39.5162 6.85821 3.72706 6.34433 1.60956 -609 4 46.9486 38.0654 7.68542 -11.5693 -5.06488 12.3189 -610 1 46.0019 35.318 4.78064 -26.4221 -3.88232 27.7903 -611 2 45.3025 34.13 4.26579 26.8092 19.3149 11.5505 -612 2 44.4585 34.46 3.02929 16.6723 1.23881 35.6677 -613 3 44.3932 33.6565 2.12406 -6.96945 -13.3218 -23.6344 -614 4 45.6895 35.6839 5.72645 6.17072 -11.3773 -21.4598 -615 4 46.1371 33.4525 3.9443 -9.57056 -4.48549 -9.01935 -616 2 44.5851 33.4333 5.41517 7.28023 -34.3989 -9.31284 -617 2 43.896 32.1478 4.95943 -2.5072 53.7563 23.2534 -618 3 42.6929 32.0377 5.28407 -11.6877 -17.8688 -5.68187 -619 3 44.6212 31.2997 4.42805 15.8429 -32.9345 -13.4225 -620 4 43.8908 34.1037 5.87793 -28.8167 18.0933 10.1447 -621 4 45.2673 33.1449 6.25678 1.67129 3.14432 -6.05002 -622 1 43.9425 35.6996 2.93756 -0.354949 -32.7532 -51.8723 -623 2 43.3733 36.2033 1.70184 -38.6892 -13.1006 14.7431 -624 2 44.3694 36.8017 0.73913 15.0439 4.82349 -39.1461 -625 3 44.0609 36.9601 41.4463 -0.757384 -5.0254 19.6545 -626 4 44.0082 36.3398 3.67638 4.88567 37.3717 42.7902 -627 4 42.8639 35.3314 1.17484 15.8753 7.76257 0.915116 -628 2 42.1931 37.1947 1.98861 35.687 20.598 -23.7763 -629 2 41.116 36.6037 2.88066 -6.28281 10.7168 27.7809 -630 2 39.8788 37.4748 2.97821 -20.6793 -12.2331 -39.8799 -631 3 39.5744 38.0012 4.02693 -4.5695 14.1805 28.3661 -632 1 39.0796 37.534 1.86047 23.989 -9.69865 9.57867 -633 4 41.7899 37.5369 1.00167 -6.59533 -6.76427 4.06671 -634 4 42.6371 38.1477 2.39011 -7.96796 -7.2267 7.32793 -635 4 41.4745 36.4913 3.95075 -0.75248 -0.913082 -13.6466 -636 4 40.7949 35.61 2.55083 -3.16107 -12.1939 -5.02302 -637 4 39.3636 37.1043 0.951835 -4.89499 3.13933 11.6446 -638 4 38.1602 37.9899 1.92801 1.07188 2.17452 -2.18356 -639 1 45.5977 37.1878 1.1702 -15.0402 3.91697 -26.2999 -640 2 46.6124 37.7593 0.269692 0.961344 -25.1749 -6.20454 -641 2 47.1251 36.6298 41.227 -15.6894 27.1972 18.7996 -642 3 47.6617 35.6605 41.7393 11.2436 -21.3221 -9.23089 -643 4 45.7953 37.0706 2.14421 15.4189 2.49224 25.3654 -644 4 46.1246 38.4981 41.5406 -7.74237 14.7139 -7.84953 -645 2 47.8075 38.4099 1.03092 10.1012 15.6193 -18.1996 -646 2 47.4246 39.6903 1.82563 -12.4684 -22.6418 23.6998 -647 2 48.6005 40.4099 2.51691 -17.3417 -7.9082 6.23218 -648 3 49.6876 40.5582 1.97833 4.99301 -0.872474 -9.60266 -649 1 48.339 40.8761 3.75079 34.2245 13.1834 24.2049 -650 4 48.6123 38.7237 0.293834 -9.9427 -4.45455 6.13719 -651 4 48.2879 37.6501 1.66455 2.7768 -3.8165 9.90104 -652 4 46.6323 39.34 2.60232 21.0344 18.1725 -15.5096 -653 4 46.9544 40.4315 1.1644 -6.65764 6.44375 -5.56957 -654 4 47.4103 40.9551 4.17425 -6.86232 -2.61251 -1.04516 -655 4 49.1568 41.2536 4.3255 -23.3959 -10.5461 -18.532 -656 1 47.0132 36.8194 39.8944 4.79393 -10.5252 -5.84263 -657 2 47.6604 36.043 38.8342 19.1375 -30.0942 8.85154 -658 2 48.4687 37.0132 37.9763 6.82075 18.1877 -22.3602 -659 3 47.9595 37.6039 37.0009 8.77071 -9.81154 18.2462 -660 4 46.405 37.5569 39.5258 -2.34297 5.9549 -2.23138 -661 4 48.4229 35.2731 39.2798 -19.3933 25.0679 -4.92238 -662 2 46.6775 35.1997 37.9517 0.490197 24.678 -10.7229 -663 2 46.0672 34.0096 38.7198 -38.9175 -0.700818 10.3629 -664 2 46.8744 32.685 38.9073 -3.26917 9.79703 -36.9848 -665 1 47.7628 32.6295 40.0786 -15.9706 28.2316 14.6984 -666 2 48.51 31.5331 40.3435 -4.63001 14.745 41.8738 -667 1 48.7312 30.5422 39.5064 -7.34995 -4.23697 -9.55446 -668 1 48.9018 31.3819 41.635 -19.9532 28.2508 -37.0556 -669 4 47.1729 34.8887 37.0027 6.80802 -10.5296 7.48075 -670 4 45.9076 35.9114 37.5121 1.10402 -9.8189 16.5264 -671 4 45.0997 33.7597 38.1755 17.1722 -3.36537 -3.11703 -672 4 45.6001 34.3514 39.6854 13.8349 -0.884929 -1.62484 -673 4 47.4022 32.4647 37.9216 2.87405 7.70981 18.3952 -674 4 46.1271 31.862 38.9206 0.553217 -4.0431 12.8995 -675 4 47.6279 33.4362 40.8042 9.43822 -37.2826 -24.9694 -676 4 48.3342 30.5657 38.5603 0.826291 -3.97588 -2.82687 -677 4 49.185 29.675 39.7859 6.04467 -9.07236 4.91997 -678 4 48.5432 32.0104 0.443983 -2.47374 7.53927 7.97734 -679 4 49.3442 30.5519 41.958 17.8055 -32.7958 11.0172 -680 1 49.7507 37.2761 38.36 -27.9891 3.94923 -10.3626 -681 2 50.6372 38.1716 37.6465 6.90802 9.01894 -16.7299 -682 2 51.1009 37.4739 36.3314 6.00851 -0.000986305 0.302592 -683 3 51.4496 36.2941 36.3505 -3.04594 -4.29189 2.8804 -684 4 50.1774 36.6397 39.0138 14.1864 -12.0724 14.4781 -685 4 50.0595 39.0583 37.2837 -1.51256 1.6517 8.14679 -686 2 51.8464 38.6091 38.5553 2.49074 0.426256 -22.3009 -687 2 51.5192 39.49 39.8069 -13.5557 -5.73698 -8.16935 -688 2 52.7888 39.6608 40.6664 -21 22.821 44.9745 -689 2 51.0354 40.8913 39.3667 -19.684 19.0705 -14.0846 -690 4 52.5817 39.1556 37.8894 -7.88883 -2.40182 8.97054 -691 4 52.3725 37.6699 38.8321 2.26719 1.04002 8.03718 -692 4 50.6848 39.0041 40.3963 9.50705 2.70236 -0.692257 -693 4 52.9505 38.8088 41.3668 0.716139 -3.31122 -6.89789 -694 4 52.7117 40.5855 41.3722 -1.5977 -23.2904 -18.3054 -695 4 53.6872 39.819 40.0903 21.6097 1.4026 -14.7648 -696 4 51.7777 41.4333 38.7338 5.73144 0.910017 10.7761 -697 4 50.6933 41.5309 40.2327 12.7628 -5.43827 -4.45399 -698 4 50.1361 40.9136 38.7005 3.06807 -14.6998 5.44273 -699 1 51.1637 38.2069 35.1833 -8.65277 46.2898 44.1617 -700 2 51.553 37.7419 33.8846 1.56046 15.8517 -26.9219 -701 2 52.7972 38.5563 33.3946 6.24297 -42.3048 -4.64985 -702 3 52.8896 39.7642 33.5814 -6.435 17.9384 2.35192 -703 4 50.9569 39.2647 35.262 8.21378 -41.2603 -12.3383 -704 4 51.8027 36.6701 33.8819 4.46523 -10.0245 6.73196 -705 2 50.2986 37.9511 32.9329 -9.17145 -5.64023 18.3882 -706 2 49.0629 37.0889 33.4059 8.5101 -2.50878 -15.0431 -707 2 50.6601 37.6697 31.4816 -9.00198 -6.28682 -34.5666 -708 2 49.2037 35.5513 33.2317 13.0867 -6.63955 11.9256 -709 4 49.9372 39.0006 33.0238 8.27291 6.69816 -3.39278 -710 4 48.1686 37.4323 32.8001 8.11156 -5.69031 9.58675 -711 4 48.8477 37.3684 34.464 -5.28515 -5.82898 -0.156702 -712 4 49.7508 37.5287 30.8047 12.011 -0.0430796 16.0089 -713 4 51.2928 36.7446 31.376 -4.11156 8.47591 0.32382 -714 4 51.1768 38.5507 31.0175 4.51478 -6.96789 5.36543 -715 4 50.1453 35.1216 33.7014 -11.0082 12.206 -5.4516 -716 4 49.2178 35.23 32.1578 -3.59036 3.22922 4.55632 -717 4 48.3665 35.0295 33.7638 0.68062 2.42879 -7.65558 -718 1 53.772 37.8505 32.7005 11.9802 38.3584 -9.99311 -719 2 54.8892 38.4918 31.9453 -18.9337 33.3604 36.4373 -720 2 0.0457823 37.9282 30.5422 -8.24024 2.92716 -24.5162 -721 3 0.594264 36.8423 30.3259 -11.3073 1.50903 5.31397 -722 4 53.7906 36.8495 32.616 -6.44893 -30.0966 2.1434 -723 4 54.5933 39.6185 31.9763 4.67753 -27.1194 -20.6963 -724 2 1.30394 38.4484 32.6241 4.82921 -5.73508 14.5601 -725 2 2.2605 39.423 31.9346 -38.1373 19.2777 23.8899 -726 2 1.83713 40.7771 31.9484 17.1926 2.24265 -1.86924 -727 2 3.4991 39.1266 31.4137 44.2785 -3.28979 -22.8275 -728 2 2.64242 41.8019 31.4282 -29.5168 1.86603 13.0701 -729 2 4.3212 40.1796 30.8558 3.27898 -39.2743 8.81887 -730 2 3.87185 41.4777 30.8782 6.24363 43.3598 -8.15054 -731 4 1.73925 37.4095 32.5315 -6.00214 7.91305 5.68876 -732 4 1.22265 38.7505 33.7444 5.52003 -9.57077 -28.715 -733 4 0.900292 41.0813 32.4345 -2.25415 1.01323 1.36593 -734 4 3.85804 38.0586 31.4239 -1.87041 17.6471 -1.97414 -735 4 2.21075 0.929728 31.5263 16.6224 -11.4708 -8.14622 -736 4 5.34427 40.0148 30.4252 -14.7168 -7.47964 5.81345 -737 4 4.49601 0.410438 30.4759 -4.95559 -13.7664 3.94973 -738 1 54.5157 38.6773 29.5249 -27.0888 35.6462 7.20647 -739 2 54.4663 38.361 28.1069 5.2815 -2.56059 -27.0064 -740 2 53.8105 37.007 27.8285 4.1142 -30.4598 -15.4676 -741 3 54.2925 36.1623 27.0158 -8.84 24.3654 24.6709 -742 4 54.0165 39.6075 29.7175 18.6271 -30.7219 2.56864 -743 4 53.83 39.1099 27.5328 0.819814 -7.88342 20.1611 -744 2 0.845681 38.4599 27.4009 -3.37868 13.1124 0.920574 -745 4 1.3644 39.4179 27.7359 0.635395 -16.0183 -8.53916 -746 4 0.720089 38.4757 26.2839 -0.330424 7.67272 7.0695 -747 4 1.43916 37.5478 27.5772 11.0328 -1.07232 10.5421 -748 1 52.6562 36.7643 28.4919 4.43857 42.1876 29.7882 -749 2 51.8688 35.5726 28.5678 11.3762 10.3615 -9.24037 -750 2 52.1836 34.677 29.7554 -56.6515 -45.7393 26.8579 -751 3 51.2796 33.8674 30.1477 33.9368 21.5747 -13.7315 -752 4 52.2409 37.5914 29.034 7.3769 -32.5773 -16.326 -753 4 50.8037 35.9045 28.6197 0.824464 -11.9292 4.40922 -754 4 51.9818 34.9789 27.6186 -1.74208 2.17118 9.08886 -755 1 53.386 34.609 30.3327 15.9463 0.295407 3.2668 -756 2 53.8702 33.5918 31.2906 -5.336 7.3854 -1.97925 -757 2 53.2724 33.784 32.6972 3.62039 -3.18208 -20.5224 -758 3 53.318 34.8834 33.2435 -3.37109 6.20646 2.08258 -759 4 54.0584 35.341 30.1321 12.3398 9.17802 -3.54281 -760 4 53.5469 32.5903 30.928 0.510164 -2.93777 -2.78072 -761 2 0.450375 33.6574 31.3834 -19.8167 20.6669 9.28695 -762 2 1.1189 33.1041 30.1021 -5.33927 -7.82927 4.13606 -763 2 2.62926 33.3565 30.0201 27.5042 -3.46073 -5.185 -764 2 3.52676 32.4236 30.898 -7.76336 10.6891 3.26174 -765 1 4.93921 32.7908 30.8651 -15.3408 -23.1293 6.29736 -766 4 0.715906 33.1135 32.3077 13.219 -7.49284 0.339296 -767 4 0.711888 34.7596 31.5921 3.25804 -21.2431 -6.20467 -768 4 0.610971 33.6189 29.2485 6.53106 -4.93764 -4.86032 -769 4 0.94328 31.9817 29.9891 -3.372 16.4508 0.497364 -770 4 2.92569 34.3879 30.2717 -10.3735 11.8265 3.32189 -771 4 2.96748 33.277 28.9434 -5.36763 -4.46501 9.75656 -772 4 3.3856 31.3899 30.5364 6.91643 -9.08032 2.48396 -773 4 3.23325 32.4634 31.9813 -4.58699 -1.94284 -9.93441 -774 4 5.35439 32.7181 29.9584 6.30767 5.94328 -10.9381 -775 4 5.52691 32.2429 31.4849 -0.455553 -3.36681 1.56927 -776 4 5.05493 33.7218 31.1915 7.72328 25.1707 0.250012 -777 1 52.7526 32.6794 33.2917 -1.1678 -10.0217 7.16811 -778 2 52.3607 32.6823 34.7156 1.10255 -1.80451 -46.4405 -779 2 53.6298 32.9771 35.466 24.3124 -3.86391 3.03884 -780 3 54.7252 32.4235 35.2212 -23.0397 10.722 4.71956 -781 4 52.6718 31.7771 32.7765 -0.499018 10.5241 3.64804 -782 4 51.648 33.5318 34.8013 -6.43996 -0.39665 8.9378 -783 2 51.7643 31.3153 35.1205 -14.6608 -0.598675 31.299 -784 2 50.4472 31.4454 35.9643 8.77941 -15.5352 -26.1807 -785 2 50.5832 31.9625 37.3651 -2.67912 16.3525 37.5763 -786 3 49.9209 32.9494 37.7433 9.07957 -2.58057 -6.15032 -787 1 51.437 31.3297 38.2211 2.67596 1.57171 0.930055 -788 4 52.5216 30.7277 35.7054 -4.20254 0.0350677 -4.46682 -789 4 51.4878 30.6783 34.2719 3.29993 -4.42069 -15.0162 -790 4 49.9434 30.4567 35.9623 3.78404 -4.63917 10.5702 -791 4 49.6858 32.0412 35.427 2.21977 11.0074 -1.38139 -792 4 51.8063 30.3924 37.9705 2.16328 6.00798 1.3625 -793 4 51.6437 31.7399 39.1747 -6.68696 -10.5036 -22.3596 -794 1 53.5095 33.8962 36.42 -8.20166 25.4414 22.1973 -795 2 54.5747 34.3024 37.3295 -19.3274 -47.2338 19.7644 -796 2 54.3374 33.5175 38.6424 -52.3016 59.5202 -10.0971 -797 3 53.3688 33.7998 39.3891 18.863 -9.21915 -6.06634 -798 4 52.6243 34.4292 36.5865 8.7567 -9.68897 -5.69769 -799 4 0.524888 33.8606 36.995 20.2449 10.0463 -17.6441 -800 2 54.6326 35.7977 37.4305 -12.9517 47.1344 28.5316 -801 2 0.0326923 36.4499 36.0829 -2.43572 -2.53932 -10.8482 -802 2 0.0400304 37.9734 36.2703 -35.7369 26.7596 -9.32276 -803 2 1.42323 35.9178 35.6511 7.48175 21.564 37.2538 -804 4 0.37702 36.205 38.1946 -7.23177 -18.0499 -4.52301 -805 4 53.6103 36.1739 37.8346 22.3749 -7.86488 -15.795 -806 4 54.308 36.1878 35.2646 -5.73883 1.17112 4.65385 -807 4 54.1487 38.389 36.8719 12.989 -15.5349 -14.8375 -808 4 55.0091 38.5546 35.2982 1.66458 -12.2972 11.8538 -809 4 0.898146 38.314 36.8215 26.4509 7.27198 12.604 -810 4 1.38795 34.9003 35.2548 1.76467 -17.1685 3.06812 -811 4 2.15782 36.0461 36.5409 -11.2535 -11.763 -23.0993 -812 4 1.84494 36.4876 34.8385 7.70144 16.3511 -18.9114 -813 1 0.00368541 32.3928 38.6933 60.3495 -72.1401 -12.2197 -814 2 54.849 31.2911 39.6724 -12.054 11.0917 -33.5573 -815 2 0.456178 31.7903 40.9874 10.6429 2.84259 -7.8967 -816 3 1.61925 32.1816 41.0469 -1.25889 2.69502 -0.320895 -817 4 0.771148 32.2113 37.9508 -27.5595 2.34137 31.2634 -818 4 53.7516 31.0568 39.7052 4.35339 2.80588 13.4321 -819 2 0.572301 30.0297 39.0906 18.5839 -9.3637 1.30639 -820 2 0.330271 28.7129 39.848 -4.85336 -14.889 23.6916 -821 2 0.693398 28.6486 41.365 -25.7394 -2.5332 -16.7842 -822 3 54.7394 28.745 0.295995 1.88939 6.38348 7.55667 -823 3 1.88537 28.4667 41.718 12.1129 0.623711 3.73015 -824 4 1.68124 30.2872 39.0755 -12.926 -11.288 -1.20667 -825 4 0.269733 29.7427 38.025 4.32739 20.9521 12.5377 -826 4 0.909417 27.8521 39.409 -5.73579 9.2082 -7.491 -827 4 54.2152 28.4395 39.7334 16.9231 1.48772 2.1114 -828 1 54.6305 31.7883 0.132952 22.8608 6.07746 39.2243 -829 2 54.8576 32.3299 1.48573 -29.3221 31.1311 -21.4901 -830 2 1.17253 32.0229 2.2009 17.6366 -16.111 10.5973 -831 3 1.59057 32.8071 3.07156 -0.674056 0.0659302 -13.788 -832 4 53.659 31.6017 41.9208 -28.5726 -8.3455 -12.917 -833 4 54.8441 33.4787 1.30532 5.06012 -29.8204 14.0187 -834 2 53.6539 32.0394 2.47663 -0.820586 10.1398 -23.6755 -835 2 52.2239 32.3686 2.01123 21.8921 -9.62397 -13.268 -836 3 51.4302 33.0165 2.73635 3.85378 3.64717 10.9914 -837 3 51.8951 32.0293 0.84168 -3.94391 -2.23918 -4.0609 -838 4 53.7898 32.6162 3.39279 8.30271 4.42614 18.4259 -839 4 53.7249 30.9715 2.71423 -6.48233 -12.4206 11.3701 -840 1 1.80027 30.8157 2.00429 -3.41308 17.021 -11.1273 -841 2 3.01391 30.3872 2.67306 -17.4243 6.23421 51.1709 -842 2 4.3573 30.5827 2.00701 -14.1548 15.4243 -63.5733 -843 3 5.42088 30.6338 2.61698 6.51202 -0.211014 15.7475 -844 4 1.38736 30.0831 1.41283 -0.948729 3.54349 -2.60962 -845 4 3.08525 30.9412 3.69277 -1.85342 -9.762 -26.0847 -846 4 2.85031 29.3254 2.98975 11.9317 8.24793 -5.27874 -847 1 4.28888 30.743 0.620497 -12.3621 7.32386 22.4338 -848 2 5.32937 31.2764 41.6512 -13.8663 -29.5394 -9.66616 -849 2 5.57121 32.722 0.10225 -38.3787 16.5244 28.1783 -850 3 4.67744 33.4061 0.685107 26.0808 -18.0695 -15.0621 -851 4 3.36015 30.6914 0.159011 7.3551 0.286523 4.85155 -852 4 6.25759 30.6643 41.7722 1.97617 9.44883 5.82281 -853 2 4.84937 31.1813 40.1487 29.2597 0.863212 8.06821 -854 2 4.69879 29.8019 39.4857 10.4894 -21.0831 -13.1113 -855 2 5.6473 28.6668 39.9936 -13.3021 -14.9024 -16.8737 -856 1 5.27077 28.179 41.3306 -2.96519 4.49812 -11.7353 -857 2 6.06985 28.0105 0.470368 18.4061 -2.74343 27.4639 -858 1 7.404 28.2193 0.415809 -33.9112 -6.97322 0.0250223 -859 1 5.53751 27.6715 1.66745 7.41355 -4.5447 5.6764 -860 4 5.59287 31.7875 39.5584 -6.62026 -5.01092 -0.797873 -861 4 3.90042 31.6963 40.0361 -18.37 16.2558 -2.13315 -862 4 4.87993 29.9347 38.3602 -5.0628 -2.10161 17.6043 -863 4 3.66163 29.4121 39.5629 -5.01534 4.60088 1.06729 -864 4 6.67981 29.0441 39.9161 8.56645 -0.645935 3.00783 -865 4 5.57604 27.7587 39.2774 2.4211 23.1794 17.5601 -866 4 4.26853 28.0084 41.463 -5.17362 0.488763 -0.181308 -867 4 7.82192 28.2777 41.397 19.0269 3.46358 -1.03101 -868 4 7.9555 28.2212 1.28205 9.21585 -1.90571 -0.36079 -869 4 4.50489 27.4888 1.75639 19.7441 2.64647 4.92685 -870 4 6.15841 27.5559 2.53009 -21.7479 0.642981 -21.0512 -871 1 6.76075 33.214 41.6912 19.219 -12.8447 -16.8584 -872 2 7.12868 34.5749 41.8436 1.78261 35.3429 43.0116 -873 2 6.77609 35.3298 40.5962 -19.1975 -45.9981 -46.2181 -874 3 6.48326 34.7082 39.534 6.6414 26.9902 28.4778 -875 4 7.37626 32.7254 41.0127 -5.73863 2.32833 8.30529 -876 4 6.55071 35.0559 0.812315 8.37617 -12.7412 -20.2377 -877 2 8.6392 34.7953 0.238234 19.5739 7.90851 -48.6006 -878 3 9.35353 34.1854 41.0304 -12.8386 -4.95727 8.3137 -879 2 9.11551 34.1669 1.50873 -18.8724 -23.6236 42.9663 -880 4 8.9088 35.8955 0.234805 -6.25165 -9.40588 3.92441 -881 4 10.2786 34.3917 40.988 -0.40493 9.85267 11.4657 -882 4 10.1184 34.4515 1.79035 25.1513 6.04912 0.147779 -883 4 9.07131 33.0605 1.52977 2.37755 -2.72972 -9.56943 -884 4 8.50911 34.4369 2.41136 -0.948376 7.25744 -9.18832 -885 1 6.94474 36.6394 40.6556 -2.44135 26.6434 -23.8261 -886 2 6.9184 37.5467 39.5347 6.69905 -14.1713 -12.8446 -887 2 8.05389 37.1964 38.5245 -27.4859 18.9986 34.7956 -888 3 7.86013 37.2053 37.325 -9.29767 -2.30205 -27.2404 -889 4 7.0965 37.1097 41.5252 4.96112 6.67936 34.6112 -890 4 5.99819 37.3272 38.9586 -4.63141 4.06603 -3.57729 -891 2 6.96111 39.0217 40.0249 7.60343 4.99798 32.9439 -892 2 5.64771 39.5459 40.7503 13.3303 -11.7686 1.87571 -893 2 5.75985 41.0532 41.0609 20.2812 5.99168 -41.4278 -894 2 4.32816 39.2726 39.9704 18.565 3.35099 -29.4893 -895 4 7.21258 39.6788 39.2071 1.58444 12.8598 -26.2647 -896 4 7.87294 39.1662 40.7418 -24.807 -6.41168 -15.2883 -897 4 5.6203 39.0148 41.7319 -7.34537 -3.15131 1.25362 -898 4 4.91646 41.4032 41.6252 -26.0876 7.76092 9.54018 -899 4 5.84653 41.6805 40.0749 -1.44823 -14.0856 28.5036 -900 4 6.60816 41.2866 41.7276 9.52725 -0.69638 -3.08419 -901 4 4.29893 39.8385 38.99 0.215491 -3.12837 12.3269 -902 4 3.42741 39.5069 40.5265 -12.1672 8.54215 8.82184 -903 4 4.17367 38.2217 39.6869 7.24572 -5.84244 0.858739 -904 1 9.22626 36.8637 39.0427 21.4973 3.37181 48.1033 -905 2 10.3674 36.5714 38.2232 -9.10154 -9.23991 0.387697 -906 2 10.2983 35.2598 37.4643 -7.87493 -21.516 -1.82692 -907 3 11.0121 35.0941 36.4546 -10.096 5.18496 3.08952 -908 4 9.43559 37.0753 40.0799 -6.60045 -9.32212 -38.2223 -909 4 10.38 37.3229 37.4195 5.65865 10.6121 -8.5187 -910 2 11.637 36.6734 39.0312 17.5501 -7.37692 6.57672 -911 3 11.6795 35.7227 40.1079 -2.8679 20.1807 -0.19791 -912 4 11.748 37.6704 39.4409 -4.03165 17.0402 13.6797 -913 4 12.5247 36.6276 38.381 6.78129 -14.3562 -2.26856 -914 4 12.1944 34.9922 39.8075 10.5839 -13.8343 -8.97123 -915 1 9.37599 34.317 37.8723 17.0981 22.6825 36.4547 -916 2 9.03961 33.1663 37.0884 -21.5177 -32.5135 -8.8238 -917 2 8.42186 33.6216 35.772 12.1136 -61.8885 -37.6156 -918 3 8.46238 32.81 34.7849 1.32901 29.1307 35.9822 -919 4 8.95542 34.3811 38.853 10.4706 -4.46378 -29.0763 -920 4 9.93142 32.5518 36.7616 2.79547 16.9463 9.21372 -921 2 8.03197 32.1466 37.7484 3.42637 10.6841 -18.9321 -922 2 8.64707 31.2467 38.7916 -6.9544 1.67927 -4.64681 -923 3 8.29676 31.4213 39.9815 6.74685 -6.11142 9.13282 -924 3 9.44706 30.3423 38.4151 3.7337 3.36295 -6.87259 -925 4 7.50152 31.5448 36.9637 8.39997 -2.11551 6.41653 -926 4 7.19405 32.7023 38.1775 -8.25993 10.1263 10.5291 -927 1 7.75009 34.762 35.719 -22.4701 19.7147 -23.1057 -928 2 7.04455 35.3131 34.5484 -10.1936 -29.3849 23.8741 -929 2 7.86233 36.3488 33.8376 -13.0656 11.1044 -41.9487 -930 3 7.58485 36.6599 32.6528 -2.0293 -9.17756 21.4272 -931 4 7.63327 35.3235 36.5488 -2.91413 9.03335 17.0933 -932 4 6.86396 34.4501 33.8456 12.5342 10.3996 -5.08052 -933 2 5.61426 35.844 34.9306 19.6262 -1.52617 -28.8748 -934 2 4.83213 34.6653 35.4025 -10.2806 -24.7237 17.6593 -935 2 4.57558 34.457 36.7787 11.017 23.715 -9.65022 -936 2 4.42364 33.669 34.4835 -0.204454 17.9401 5.69744 -937 2 3.80293 33.3928 37.1817 -18.0339 -16.5573 23.9014 -938 2 3.6203 32.6104 34.8697 -1.59657 -1.57291 16.7967 -939 2 3.28719 32.4878 36.2185 14.3191 25.239 16.785 -940 3 2.42643 31.5967 36.7004 -21.786 -29.0921 6.36516 -941 4 5.08947 36.2348 33.9913 8.47084 3.13833 18.0937 -942 4 5.68856 36.6154 35.7126 -3.45102 11.3715 1.65586 -943 4 4.93536 35.177 37.5545 -2.85956 -5.82375 -8.46254 -944 4 4.68581 33.7849 33.4351 -1.13786 -0.0334624 -10.731 -945 4 3.5508 33.3312 38.3093 3.7661 -3.16504 -32.8067 -946 4 3.21561 31.8879 34.1609 -1.14089 -4.88721 -7.16666 -947 4 2.07822 31.0058 36.0335 4.80509 5.07869 -1.12919 -948 1 8.89276 36.9109 34.4697 3.08208 2.61779 2.42454 -949 2 9.71554 37.9518 33.9536 6.78836 41.9101 -7.41895 -950 2 8.87118 39.1918 33.5791 -2.83098 -3.29658 16.5328 -951 3 9.07345 39.7706 32.5156 6.00915 0.294316 2.75033 -952 4 9.0886 36.6939 35.4314 3.3626 -5.13227 22.9354 -953 4 10.4005 38.393 34.7625 -11.752 -18.5108 -5.62727 -954 2 10.5665 37.5273 32.7526 17.9231 -22.0125 -23.4044 -955 2 11.7038 38.502 32.4536 -20.96 9.74481 -37.2535 -956 3 11.6878 39.1949 31.3977 0.540028 -8.54016 25.273 -957 1 12.687 38.5377 33.3475 38.0496 20.2334 23.5086 -958 4 9.97947 37.4403 31.7814 1.01798 2.165 18.3599 -959 4 11.0193 36.505 32.8955 -2.74071 8.1052 0.988861 -960 4 12.6531 37.864 34.1655 7.32082 17.5294 -13.3715 -961 4 13.4532 39.3055 33.2787 -30.6572 -33.7139 4.421 -962 1 7.93658 39.5767 34.4996 32.6534 -23.6413 -9.43678 -963 2 7.20273 40.8089 34.5743 -2.74612 21.1773 -15.346 -964 2 8.21766 41.8982 34.9197 -3.45605 -13.7782 10.2915 -965 3 8.98784 41.7778 35.8832 -3.40272 -3.46005 -6.10842 -966 4 7.93188 38.9898 35.3424 -7.46187 6.56739 7.86278 -967 4 6.79415 41.087 33.5295 1.97546 -9.26453 20.6229 -968 2 6.06472 40.6271 35.6481 -5.08297 -2.08213 -22.9213 -969 2 4.90833 39.9858 34.8157 -12.6977 -10.7104 -3.72739 -970 2 5.64222 41.9226 36.403 -2.05312 -2.0705 -19.9517 -971 2 3.84054 39.2603 35.6406 -0.0147652 -3.33058 30.6695 -972 4 6.3943 39.8459 36.3734 2.85979 7.06395 10.3389 -973 4 5.33061 39.1839 34.1245 -4.62997 12.2623 4.99778 -974 4 4.37584 40.73 34.1591 8.26763 -2.20969 2.2716 -975 4 4.92993 41.6478 37.2106 -0.0042749 6.0371 4.19307 -976 4 5.15795 0.778755 35.7389 -1.27911 -10.984 2.34352 -977 4 6.51935 0.549814 36.8166 0.412823 -4.00159 10.9885 -978 4 3.21428 39.9846 36.2492 8.55414 -9.22464 -7.99451 -979 4 4.28582 38.4972 36.3757 -6.36125 15.4526 -14.7269 -980 4 3.14756 38.696 34.9847 -1.95473 -0.292674 -1.44435 -981 1 8.25206 1.08297 34.1638 31.3741 38.5442 9.59718 -982 2 9.18814 2.19093 34.4552 -11.7272 -14.356 -0.722089 -983 2 8.45749 3.48131 34.8023 4.76941 7.21795 3.77261 -984 3 7.24176 3.59586 34.6101 4.23254 1.41941 3.46139 -985 4 7.75397 1.25241 33.3001 -16.6469 -12.6897 -14.3012 -986 4 9.75614 1.90919 35.3591 7.11639 4.99627 7.91164 -987 2 10.1452 2.40125 33.2642 -9.36205 3.53781 1.41258 -988 2 11.145 1.26701 33.0621 15.3724 -18.5317 -10.2549 -989 2 12.3408 1.2215 34.0193 -34.6799 -20.8737 -4.25674 -990 3 13.4283 1.6066 33.6334 28.2263 9.73281 -4.88467 -991 1 12.1185 0.540183 35.1633 28.8031 2.35628 29.4382 -992 4 10.7148 3.34616 33.3936 1.59432 0.534457 -2.79864 -993 4 9.49714 2.55965 32.3759 6.01649 -0.268224 -5.10448 -994 4 11.6127 1.34439 32.0577 -0.769775 9.57011 -1.56393 -995 4 10.6933 0.251936 32.9886 -5.52334 3.35231 7.85959 -996 4 11.2139 0.219277 35.5156 -12.526 -0.0546681 -6.86711 -997 4 12.9016 0.455342 35.8573 -9.00019 3.15098 -17.6728 -998 1 9.24699 4.48326 35.2867 7.50516 -22.9453 -9.87373 -999 2 8.79457 5.81029 35.6553 19.4094 -0.44208 23.4194 -1000 2 7.94193 6.35186 34.5098 -28.0836 13.7832 22.6841 -1001 3 8.26577 6.15625 33.3485 3.32417 -1.59684 -17.5239 -1002 4 10.2626 4.25405 35.3107 -8.01304 16.2193 5.9612 -1003 4 8.1894 5.68577 36.5846 -11.6257 -0.00282829 -7.04897 -1004 2 9.97767 6.74716 36.1433 -23.7266 14.1696 -20.2452 -1005 2 11.1395 6.93836 35.1562 2.17384 -4.68321 -25.171 -1006 2 12.442 7.40754 35.8023 6.89417 23.6707 25.6501 -1007 2 12.3585 8.87197 36.3546 -17.7601 7.18701 6.16378 -1008 1 13.652 9.40345 36.7619 -5.05233 -10.0697 25.3038 -1009 4 10.4674 6.41708 37.0624 -6.17454 -12.8958 16.6295 -1010 4 9.46609 7.72624 36.4439 19.6997 -12.4825 -9.52898 -1011 4 10.8586 7.67723 34.3661 -2.31205 -2.27426 2.47252 -1012 4 11.3956 5.98923 34.5935 -8.15618 9.36142 7.97067 -1013 4 13.285 7.3766 35.0989 4.02069 -2.74272 -14.2107 -1014 4 12.7725 6.74228 36.6382 -4.94702 -0.810609 -4.3443 -1015 4 11.6162 8.97546 37.2517 21.5709 -5.37851 -23.6156 -1016 4 11.9848 9.59279 35.5592 1.32622 -13.234 7.43529 -1017 4 13.5097 10.3531 37.0548 1.1249 12.5728 4.15723 -1018 4 14.3076 9.4933 35.9914 2.38442 -5.54985 1.16984 -1019 4 14.0989 8.9471 37.5942 -8.28554 10.0467 -28.7492 -1020 1 6.74258 6.95961 34.8453 13.8439 -7.08515 -31.5666 -1021 2 5.70412 7.47847 33.9372 22.4359 17.1833 28.8896 -1022 2 4.73468 6.47268 33.3926 -37.2702 -51.3286 -21.7325 -1023 3 3.66084 6.82477 32.8505 20.0183 9.28716 8.38675 -1024 4 6.50761 7.12516 35.8163 -0.959582 1.3178 20.8718 -1025 4 5.07512 8.17388 34.5809 1.06569 -12.1955 -8.24357 -1026 2 6.27511 8.35576 32.8097 23.4106 2.51452 -13.5767 -1027 2 6.97942 9.67377 33.2004 -16.9954 14.0421 10.4255 -1028 2 6.10535 10.8129 33.826 12.866 -26.3315 -27.4761 -1029 3 5.32563 11.4369 33.048 -2.57309 4.89094 -0.177716 -1030 3 6.28787 11.1355 35.0235 5.56298 3.82152 16.5631 -1031 4 5.49496 8.55729 32.0786 -16.2509 9.70978 -5.42728 -1032 4 7.00993 7.79082 32.1666 -6.62982 -1.98309 13.432 -1033 4 7.44051 10.1227 32.2823 5.63402 -3.39012 2.91122 -1034 4 7.79617 9.4262 33.9151 4.88029 0.56984 -5.69246 -1035 1 4.9985 5.11713 33.407 24.659 21.8647 21.6253 -1036 2 4.05493 4.11234 32.9569 -19.5991 11.2557 -30.6753 -1037 2 2.66349 4.36425 33.564 5.77052 11.5327 33.941 -1038 3 2.61183 4.63212 34.7889 -10.6254 -2.1096 -24.9185 -1039 4 5.90798 4.72579 33.7623 -18.8375 16.0079 -6.75199 -1040 4 3.94963 4.2178 31.8123 4.18537 -9.18741 21.4869 -1041 2 4.52113 2.73738 33.4375 8.25229 -17.2331 29.0433 -1042 3 5.75234 2.38881 32.7881 -21.5054 -2.62865 -12.7372 -1043 4 3.76903 1.95227 33.2696 -3.85539 -5.9091 -13.5606 -1044 4 4.62925 2.69715 34.589 6.20333 6.93314 -25.3828 -1045 4 6.43526 2.61043 33.3995 7.46021 4.72267 11.925 -1046 1 1.55191 4.21884 32.8032 -14.0425 -5.15851 -21.6842 -1047 2 0.161375 4.25438 33.2368 -9.40026 13.4655 23.096 -1048 2 54.692 2.80115 33.3646 18.1492 -1.83923 -37.1888 -1049 3 54.7885 2.04564 32.3679 -9.76904 2.34815 11.9713 -1050 4 1.58614 3.87283 31.8209 11.2241 6.42129 12.946 -1051 4 0.0932821 4.78062 34.2407 6.57702 -9.00044 -6.29593 -1052 2 54.1421 5.03026 32.3092 -30.8516 -27.3257 32.8914 -1053 3 54.4529 6.38645 32.3432 43.6526 11.7784 12.1317 -1054 2 52.6693 5.00292 32.8811 18.0931 2.75777 -15.9968 -1055 4 54.1554 4.62002 31.3044 4.18983 -2.87474 -22.2473 -1056 4 53.8639 6.90955 31.8518 -25.2917 13.9269 -18.693 -1057 4 52.66 5.46781 33.8932 -7.48107 5.39969 -2.18241 -1058 4 52.249 3.98991 33.0062 0.231344 -5.48034 -3.27193 -1059 4 51.9963 5.5356 32.1423 1.66512 -1.40627 14.088 -1060 1 54.1705 2.41097 34.5199 1.80418 26.5965 31.5441 -1061 2 53.4771 1.1604 34.7223 -23.5881 -17.4143 30.2256 -1062 2 51.9672 1.43692 34.4286 45.4706 11.6959 19.6168 -1063 3 51.5098 2.51334 34.8139 -14.0548 -1.70012 -4.22959 -1064 4 54.1449 3.13072 35.3168 -2.84084 -28.6208 -21.3152 -1065 4 53.8073 0.317305 34.0552 7.54144 10.0832 -0.542806 -1066 2 53.6466 0.727247 36.2732 15.0023 -0.977243 -19.0787 -1067 2 0.11045 0.778115 36.8855 -3.47233 23.3808 -12.4462 -1068 2 0.174657 0.0352411 38.2454 9.71436 -6.65086 -1.81426 -1069 2 1.19132 0.222888 35.8995 6.11034 15.7938 3.95568 -1070 4 53.2393 41.6189 36.352 -4.11551 -11.0062 3.39296 -1071 4 53.0266 1.35722 36.9407 -10.5209 2.31976 -3.99924 -1072 4 0.276909 1.89779 37.0745 11.3679 -17.77 -1.06189 -1073 4 54.361 0.442618 38.9125 4.10216 -8.97134 2.26246 -1074 4 1.16474 0.174268 38.7716 -10.2453 4.64912 -5.91146 -1075 4 0.0894693 40.827 38.1128 -8.07449 10.5575 2.47406 -1076 4 2.18017 0.0911741 36.3628 0.498668 -8.86502 15.8712 -1077 4 1.51082 0.946112 35.1046 -21.6742 -5.82018 -4.77892 -1078 4 0.87048 41.1455 35.5035 3.84873 -0.316194 -7.96637 -1079 1 51.2572 0.510776 33.7869 -35.0849 -22.21 -18.422 -1080 2 49.7991 0.651464 33.5457 -7.89552 -1.42073 2.85742 -1081 2 49.1064 41.7127 34.6422 20.8091 24.7993 -30.4476 -1082 3 49.3211 40.5176 34.6928 0.936017 -16.9834 6.81615 -1083 4 51.5685 41.4333 33.6514 6.90564 11.6478 3.53197 -1084 4 49.4699 1.73569 33.6536 7.71362 -9.58165 1.5915 -1085 2 49.2914 0.124722 32.1435 -1.6477 0.542595 21.3952 -1086 2 49.5957 1.07684 31.016 -40.6033 -15.585 26.437 -1087 1 48.7294 1.99918 30.4836 -27.6566 13.4748 -4.54446 -1088 2 50.7297 1.21695 30.3262 36.7247 10.1326 -33.1818 -1089 2 49.2902 2.59089 29.4013 15.6758 12.8861 -16.3634 -1090 1 50.5605 2.13547 29.3267 -27.6128 -3.77706 23.4645 -1091 4 48.1729 41.8384 32.2733 14.3125 6.04861 -12.1255 -1092 4 49.7214 41.0254 31.9181 -0.443629 4.48635 2.11286 -1093 4 47.7408 2.2006 30.8029 20.1006 -6.4749 -2.25561 -1094 4 51.6449 0.698065 30.4056 15.084 -12.5894 5.57169 -1095 4 48.9104 3.2954 28.6425 -5.47018 -10.6135 19.6435 -1096 4 51.2563 2.40703 28.6421 12.9903 7.46191 -13.5301 -1097 1 48.3611 0.457254 35.523 -13.4783 35.8963 4.98689 -1098 2 47.6684 41.7265 36.6028 -12.609 2.82517 16.7739 -1099 2 46.2613 41.336 36.1362 14.2498 9.86212 -6.63619 -1100 3 45.3696 0.249228 35.9008 11.2544 -8.11188 8.40093 -1101 4 48.1527 1.47601 35.3837 2.04907 -15.0615 5.33592 -1102 4 48.2568 40.8085 36.8471 -2.89667 -2.02658 5.80089 -1103 2 47.5596 0.692305 37.8969 5.07609 12.8861 -15.4572 -1104 2 46.7247 0.067171 39.0652 -23.3887 -7.36646 -24.3057 -1105 2 47.033 40.4837 39.4166 -14.2982 16.8046 -18.6717 -1106 2 46.9311 0.907751 40.3269 20.2628 20.9695 31.7148 -1107 4 47.0803 1.72619 37.5586 18.4264 -28.4903 17.3716 -1108 4 48.6288 0.838001 38.2574 -15.841 5.68773 -4.62102 -1109 4 45.6307 0.107149 38.6982 15.4635 0.946246 17.2142 -1110 4 48.0197 40.3992 39.8616 17.8935 -6.94949 10.1905 -1111 4 47.0012 39.8155 38.524 1.84183 3.03864 3.36861 -1112 4 46.2605 40.0937 40.1174 3.5183 -0.242765 2.2201 -1113 4 48.0596 1.05972 40.5786 -27.9597 -7.64804 -5.61245 -1114 4 46.4366 0.492644 41.2461 4.13191 -4.52617 -8.48469 -1115 4 46.5029 1.93558 40.2678 1.33797 -2.98423 -8.86627 -1116 1 46.1363 40.0225 35.9719 -11.8784 -48.163 0.632693 -1117 2 44.9067 39.2611 35.7716 22.3959 0.0668878 -14.2888 -1118 2 44.4049 38.8629 37.1725 -35.2322 11.6067 -22.5418 -1119 3 45.1472 38.486 38.0617 14.0918 -2.68919 9.70234 -1120 4 46.908 39.3425 36.1226 1.34088 13.782 2.29065 -1121 4 44.2497 39.8817 35.1331 -17.245 4.97255 12.4072 -1122 2 45.2366 37.985 34.8925 -4.99104 -6.23114 -9.17669 -1123 2 44.0069 37.0072 34.8313 5.26574 11.342 7.98842 -1124 2 45.6195 38.3915 33.4226 -3.76358 -20.0352 6.70883 -1125 4 46.1177 37.4383 35.3134 -3.76426 -1.15462 7.05426 -1126 4 43.5316 36.9313 35.8696 0.358942 -6.34703 -24.4349 -1127 4 44.3242 35.9956 34.5249 4.20531 -7.16171 2.34616 -1128 4 43.2753 37.3126 34.0403 -3.87397 3.42825 10.5933 -1129 4 46.6384 38.8467 33.4221 -3.79452 2.69366 -2.61982 -1130 4 44.9004 39.1304 33.0043 0.823619 -0.608417 -3.73086 -1131 4 45.6564 37.4663 32.7381 0.0287792 19.4258 11.3413 -1132 1 43.0561 38.9062 37.36 16.7964 -0.846157 38.4014 -1133 2 42.4272 38.5172 38.6279 -14.5421 -18.7427 13.0828 -1134 2 41.8753 37.0763 38.5124 -8.78692 12.5845 -64.2445 -1135 3 41.466 36.6885 37.3717 6.29707 6.96761 32.6735 -1136 4 42.3774 39.0214 36.6331 -15.2734 7.16413 -28.2079 -1137 4 43.1919 38.4467 39.4108 16.1917 0.0561369 8.47296 -1138 2 41.3404 39.5151 39.1514 -18.2527 2.1619 5.40726 -1139 2 42.0205 40.8503 39.6333 -29.5812 13.2835 -20.5362 -1140 2 41.0689 0.171231 39.4112 30.2059 17.4331 -9.29433 -1141 2 42.4678 40.816 41.1078 15.9246 -23.8206 -10.1516 -1142 4 40.688 39.0893 39.9799 16.7303 0.907162 -6.07322 -1143 4 40.5588 39.6983 38.3606 15.4269 0.857054 0.728379 -1144 4 42.8535 41.0549 38.9416 17.5291 -0.3509 1.61726 -1145 4 41.6271 1.1561 39.6676 -14.9721 -22.7636 -0.520954 -1146 4 40.1564 0.111331 40.0029 -13.6089 -0.269988 10.9836 -1147 4 40.76 0.320829 38.3386 1.94315 -8.64923 8.74761 -1148 4 41.6626 40.4848 41.7802 -9.99726 5.60483 6.07701 -1149 4 42.8258 41.8281 41.4135 4.90552 -5.57863 6.49728 -1150 4 43.2679 40.0127 41.241 -4.54696 19.1865 -0.92221 -1151 1 41.8233 36.2733 39.5754 -3.61756 -11.0936 16.9633 -1152 2 41.1922 34.957 39.6399 -10.4088 -17.6704 -50.7121 -1153 2 39.8412 35.0841 40.3193 -0.437683 4.39576 10.763 -1154 3 39.8144 35.4746 41.4864 -9.76 5.96233 -2.547 -1155 4 42.2323 36.5766 40.4577 6.86651 4.46574 10.4638 -1156 4 40.9934 34.6386 38.4963 8.65196 -1.15376 42.0164 -1157 2 42.0562 33.8903 40.4247 20.8855 33.0106 -9.02378 -1158 2 41.3005 32.6543 41 38.0556 15.2529 -12.1112 -1159 2 42.2217 31.3951 41.1067 -29.8496 -30.3433 -13.4218 -1160 1 43.3285 31.549 0.111927 13.7517 39.8644 23.5527 -1161 2 44.3839 30.7268 0.286736 21.6234 19.2182 17.9174 -1162 1 44.681 29.6113 41.5428 -25.8767 -16.3024 -25.7307 -1163 1 45.3493 31.1499 1.13058 -39.3833 23.49 -6.35183 -1164 4 42.617 34.5166 41.192 -12.3652 -23.3828 3.531 -1165 4 42.8948 33.5841 39.7601 -4.64767 -6.80459 -5.17496 -1166 4 40.4819 32.4474 40.3056 -13.8786 -11.9041 -4.8646 -1167 4 40.8645 32.9834 0.0421702 -8.7777 -8.2778 13.4879 -1168 4 42.5872 31.067 40.0872 -0.36901 12.0823 9.30135 -1169 4 41.553 30.5032 41.4129 16.6518 20.7036 2.18161 -1170 4 43.3615 32.497 0.627799 -1.11121 -36.4642 -14.6418 -1171 4 44.0326 29.3067 40.7749 11.9664 -0.606259 12.9296 -1172 4 45.4908 28.9966 41.7635 -4.5997 7.04477 0.652143 -1173 4 45.2947 32.0222 1.6989 -3.32167 -9.1207 -8.17541 -1174 4 46.1369 30.5772 1.3332 29.28 -20.6173 7.21336 -1175 1 38.7318 34.7203 39.6307 -5.56998 -4.40152 -32.2775 -1176 2 37.3555 34.7738 40.1542 17.1032 1.0045 -6.37855 -1177 2 37.2353 33.667 41.1913 -33.3614 37.0741 40.0449 -1178 3 37.7005 32.5636 40.9891 18.731 -32.0974 -3.65368 -1179 4 38.8335 34.3404 38.6486 -6.51334 12.5121 23.5529 -1180 4 37.2672 35.7762 40.6273 -9.086 1.46109 5.84779 -1181 2 36.2453 34.5638 39.0845 -6.93832 -9.37108 -7.97374 -1182 2 36.1701 35.614 37.9414 8.91404 15.2365 -6.3275 -1183 2 35.3527 35.0344 36.7472 39.8054 8.21108 -27.9 -1184 2 35.4841 36.9314 38.4139 -18.287 13.7727 -16.8718 -1185 4 35.232 34.5024 39.5744 7.45292 -0.257102 0.0904576 -1186 4 36.3852 33.5433 38.6164 0.781265 7.17557 6.89015 -1187 4 37.2115 35.9047 37.5843 -11.2451 -10.8797 5.10717 -1188 4 35.5662 35.6385 35.778 -16.1675 -5.48794 25.897 -1189 4 34.291 34.967 37.0013 -15.7304 -0.876038 -4.35202 -1190 4 35.7074 34.0135 36.4456 -4.10332 3.28733 9.08934 -1191 4 35.4655 37.7439 37.5577 -4.97646 -27.0735 23.6494 -1192 4 36.0148 37.4196 39.237 12.1669 1.46201 8.99598 -1193 4 34.4369 36.7462 38.8365 16.8945 3.16641 -16.172 -1194 1 36.5334 33.9935 0.435925 10.1465 7.38421 -15.9691 -1195 2 36.4058 33.2568 1.6875 16.4821 -29.3274 -13.0782 -1196 2 35.1468 33.6833 2.42741 -3.52585 26.4938 2.22063 -1197 3 34.7699 34.8785 2.50349 9.50092 -20.8144 -9.83338 -1198 4 35.9506 34.8486 0.439937 7.33038 -6.12466 -5.51472 -1199 4 36.3499 32.1247 1.42412 1.62075 26.2077 7.36918 -1200 2 37.675 33.5505 2.58336 -0.681506 -6.35683 7.58589 -1201 2 37.7854 32.6927 3.8625 18.6921 -17.668 32.0141 -1202 2 39.0575 32.9332 4.76873 14.2724 -20.5826 -30.9069 -1203 1 39.1289 34.2491 5.33109 11.0713 19.2422 13.5273 -1204 2 40.0441 34.6938 6.2528 -38.5124 5.77538 -21.346 -1205 1 41.0523 34.0015 6.75388 -9.3068 -30.315 -40.8639 -1206 1 39.7573 35.8959 6.75045 4.65044 -37.6482 -19.533 -1207 4 37.7117 34.6025 2.94212 -4.78803 6.98284 -11.1897 -1208 4 38.6033 33.3783 1.98429 -1.50456 2.19712 -0.683264 -1209 4 37.8193 31.5994 3.65006 -4.42508 0.799529 -11.9295 -1210 4 36.9318 32.7949 4.56147 -11.5542 5.52665 -5.70323 -1211 4 39.9727 32.6563 4.13477 -10.3426 12.9457 13.0222 -1212 4 39.0991 32.232 5.62646 -6.41615 -9.9444 -1.6393 -1213 4 38.3112 34.8566 5.12728 9.08197 -0.1797 3.06874 -1214 4 41.338 33.0965 6.26824 1.29043 26.2885 21.8424 -1215 4 41.5567 34.3995 7.53172 18.6054 -2.34736 15.9895 -1216 4 38.9283 36.4191 6.51463 -17.6749 8.57537 -7.4588 -1217 4 40.3535 36.2619 7.44459 24.2502 25.7988 36.1589 -1218 1 34.4423 32.7029 2.99518 -5.91218 -18.2551 8.17758 -1219 2 33.2643 32.9205 3.78866 2.14491 3.18155 15.0212 -1220 2 32.3114 31.74 3.93685 27.6029 1.93064 -50.2862 -1221 3 31.6521 31.6162 4.95167 -20.1995 -6.42992 23.3772 -1222 4 34.7506 31.7123 2.9878 2.11082 4.57648 -1.08475 -1223 4 33.5885 33.2179 4.82725 -4.56531 -3.45872 -11.3922 -1224 4 32.6993 33.791 3.40271 -6.19117 1.50996 -1.33542 -1225 1 32.2733 30.8792 2.86255 -3.44833 -0.807911 26.2314 -1226 2 31.5067 29.6456 2.87911 -22.6819 -12.0155 6.38652 -1227 2 32.0275 28.5204 1.99364 -17.4826 -15.7648 -26.1521 -1228 3 31.24 27.9052 1.1757 18.2868 13.9435 17.0259 -1229 4 32.9257 31.0189 2.07167 -6.99587 -10.4877 -2.31778 -1230 4 31.4409 29.1882 3.92659 1.7726 14.0477 -11.6562 -1231 4 30.4172 29.8482 2.57519 20.7941 0.876843 7.98191 -1232 3 33.2432 28.1769 2.02662 6.75216 10.2675 5.6015 -1233 6 29.6689 33.0345 2.6027 6.39732 3.7635 -6.59735 -1234 4 28.7656 33.0857 2.95028 -0.371973 -14.4593 -6.85361 -1235 4 29.8153 32.1814 2.14015 -8.59972 11.6466 4.8732 -1236 6 1.91326 24.7635 28.0772 5.65317 -6.35183 16.4854 -1237 4 1.01929 24.4316 28.2568 3.94453 1.46201 -0.938269 -1238 4 2.46517 24.4471 28.8255 -6.59296 2.11781 -11.8027 -1239 6 8.98979 35.4216 7.06427 2.13264 0.908259 -3.07356 -1240 4 8.22375 36.0041 6.95701 -0.608539 -3.26387 0.365744 -1241 4 9.74616 35.991 6.87666 4.70766 2.91314 -0.442423 -1242 6 37.9357 35.2342 23.5273 -23.102 9.18642 19.8247 -1243 4 37.5041 35.2968 22.6705 0.513901 -3.82007 -8.89977 -1244 4 38.8432 35.0218 23.4038 20.8563 -8.17935 -11.4372 -1245 6 11.3793 34.6137 20.3253 14.1507 4.32837 -4.20952 -1246 4 10.4755 34.624 20.6003 -22.0831 6.77293 1.73618 -1247 4 11.7264 33.9016 20.8561 13.9299 -11.0914 4.04985 -1248 6 3.06607 13.1144 13.5167 22.577 18.8722 18.6067 -1249 4 2.20388 12.8262 13.8046 -7.02328 -4.57126 0.810516 -1250 4 3.32154 13.8092 14.1761 -2.44089 -14.0351 -15.8923 -1251 6 9.17443 22.3777 24.8954 -7.42914 3.56866 8.74917 -1252 4 9.07626 22.0242 24.0039 2.26474 -2.4656 -3.7019 -1253 4 8.26912 22.4958 25.2295 3.15193 -1.43545 -3.27774 -1254 6 31.1464 36.1236 7.45234 10.6607 -18.1227 -24.2194 -1255 4 30.9334 35.2222 7.12747 -5.34615 12.6105 12.538 -1256 4 31.8314 36.3443 6.79825 -5.43643 8.62165 8.26122 -1257 6 20.3227 0.172698 30.1419 10.3105 -3.05703 7.76208 -1258 4 20.0388 1.0684 29.8874 5.3247 -3.32009 0.781739 -1259 4 21.2583 0.228399 30.4322 -11.2768 6.47679 -5.28094 -1260 6 32.6859 3.01778 5.15829 -10.6028 -19.0303 43.6625 -1261 4 32.0356 2.3058 5.02019 7.54008 9.83835 -8.28794 -1262 4 32.7128 3.00557 6.15578 5.12118 6.62375 -23.7252 -1263 6 26.2374 8.27856 11.5971 17.869 0.788073 20.0593 -1264 4 26.2346 7.39991 12.0216 -0.142457 7.42091 -4.28305 -1265 4 26.8978 8.79254 12.1302 -17.5189 -15.6641 -18.5798 -1266 6 1.09614 20.2561 0.875192 -22.9747 0.467748 19.1373 -1267 4 0.851949 19.3199 1.10255 19.4844 20.3298 -11.3195 -1268 4 1.85437 20.3448 0.297385 12.1513 -16.76 -9.59627 -1269 6 29.1514 22.9126 1.42851 -3.57267 15.5796 12.2113 -1270 4 28.6966 23.7416 1.67141 5.52941 -12.1705 -9.88265 -1271 4 29.6634 22.7027 2.22543 0.165437 -2.26551 -2.85175 -1272 6 34.1399 34.826 6.47271 -4.00425 12.5535 -7.93856 -1273 4 34.8635 34.3401 6.10458 13.259 -3.54932 -9.87122 -1274 4 33.9387 34.3337 7.25184 -8.28913 -2.66912 16.7304 -1275 6 25.1643 37.1931 26.5228 17.2229 -22.0393 -23.1844 -1276 4 24.6935 37.7676 27.1042 -4.31343 22.2846 18.4719 -1277 4 26.0117 37.6203 26.271 -7.79876 5.52479 6.28113 -1278 6 14.5333 22.2337 15.6719 -21.8235 -40.5779 4.16881 -1279 4 14.0435 21.3187 15.7268 23.5152 50.9834 -4.51283 -1280 4 14.2451 22.7392 14.8947 -1.224 -10.8945 3.63574 -1281 6 2.86145 5.86342 4.09514 -12.0928 12.5672 -7.55007 -1282 4 3.31871 5.53612 4.87755 -0.114002 3.3263 11.1441 -1283 4 2.36891 6.69134 4.30817 11.5092 -15.7361 4.93451 -1284 6 27.6072 26.7133 22.7037 11.3111 -21.4893 35.9413 -1285 4 26.8221 26.1673 22.7712 -7.10606 -4.70529 -2.97044 -1286 4 27.5145 27.2572 21.9514 -10.0855 20.8317 -32.7258 -1287 6 17.7799 0.609907 22.4001 -5.17757 10.6635 4.04288 -1288 4 17.0763 0.657064 23.0885 11.5181 4.04392 -9.91171 -1289 4 18.0806 1.5364 22.261 -7.85301 -10.5281 2.59652 -1290 6 8.08893 9.42761 10.5595 3.55537 5.25916 40.324 -1291 4 7.89361 10.322 10.3179 -9.19974 15.7377 -19.3495 -1292 4 8.16563 9.56196 11.5399 2.2102 -21.2534 -20.7584 -1293 6 15.3508 8.71886 30.755 5.09068 -14.416 21.7005 -1294 4 15.721 8.98141 29.9127 -5.17651 10.4904 -11.2194 -1295 4 14.5411 9.19598 30.997 6.64715 3.62724 -9.30987 -1296 6 11.0273 17.2714 37.5546 -8.62993 4.63856 -3.16721 -1297 4 10.646 18.1523 37.5049 13.3861 11.3255 -4.88271 -1298 4 10.2437 16.8378 37.8681 -2.55755 -24.0409 7.53141 -1299 6 42.0954 25.1585 20.3881 14.6842 1.84925 -24.6227 -1300 4 41.6997 25.8318 19.7943 -2.16553 -3.48259 16.6789 -1301 4 41.6994 25.1952 21.2528 -9.02961 7.39914 10.888 -1302 6 25.8656 4.70522 33.8434 4.94337 -17.9304 30.0995 -1303 4 25.7948 4.41246 32.9437 -1.56424 4.53154 -20.9619 -1304 4 25.7821 5.65919 33.9019 -2.93726 10.638 -9.31877 -1305 6 28.7565 10.7943 24.343 5.31048 -5.66707 -17.5237 -1306 4 29.0395 10.691 25.2776 6.61806 -8.7001 -20.887 -1307 4 29.3174 10.2678 23.7025 -8.86987 6.64124 26.5787 -1308 6 5.00601 41.813 11.1 6.11697 -35.3303 28.6791 -1309 4 5.97939 41.6679 11.0741 -12.7816 8.03831 -2.02432 -1310 4 4.68345 41.1078 11.7429 5.5471 25.1349 -25.8779 -1311 6 51.7607 12.785 30.1531 41.9873 7.8243 6.58168 -1312 4 51.5044 13.1989 29.3224 -3.76645 3.26875 -7.63234 -1313 4 52.7548 12.9452 30.2104 -29.821 -7.22149 1.35463 -1314 6 7.60527 6.19156 6.53697 16.5093 0.883216 -0.386471 -1315 4 6.7728 6.50088 6.91441 -4.77803 -9.70632 -1.71599 -1316 4 7.48617 5.31021 6.15237 -11.2115 3.19853 1.4886 -1317 6 14.6639 26.9856 30.1439 5.75321 15.8705 11.2484 -1318 4 14.5566 27.0259 31.1175 -3.12227 -7.05885 -13.9758 -1319 4 15.1715 27.7926 29.9326 -6.11328 -7.83436 0.701957 -1320 6 15.3386 3.73742 21.1629 -49.5233 -4.42818 1.41573 -1321 4 14.7513 4.15862 21.8308 22.5595 -2.74077 -5.2282 -1322 4 14.679 3.20837 20.6508 28.7222 9.19721 3.95726 -1323 6 18.6168 30.4391 6.46727 22.6827 -23.6706 30.2016 -1324 4 19.0357 29.7477 7.08277 -19.2097 26.0479 -21.7287 -1325 4 19.3376 31.0911 6.37388 -10.7119 -2.89972 -1.77141 -1326 6 40.7683 1.30949 12.8061 -7.58564 4.37034 -9.51004 -1327 4 39.8743 1.70123 12.8539 8.02325 -2.8267 0.614513 -1328 4 41.1302 1.62292 11.9594 1.79027 -4.37486 1.66609 -1329 6 17.747 20.7401 41.5828 -14.5708 23.9699 -22.25 -1330 4 16.8287 21.1121 41.5273 18.852 -12.8662 8.2158 -1331 4 18.269 21.3043 40.983 -0.296974 -7.34806 11.4382 -1332 6 20.4522 2.1467 12.3338 -13.8993 16.4183 -18.7538 -1333 4 19.8428 1.38545 12.4588 7.32118 14.6694 -7.56396 -1334 4 20.1591 2.61844 11.4836 4.96023 -26.6086 29.2353 -1335 6 9.8437 37.1731 18.0697 32.5344 -3.69518 -7.02483 -1336 4 9.9915 37.607 18.9153 -11.6933 2.16478 7.61773 -1337 4 10.7629 37.1686 17.7045 -22.2666 -4.61022 -1.39483 -1338 6 22.8273 7.39987 18.8956 -5.5011 7.28813 -36.492 -1339 4 23.2632 7.84344 18.1165 -7.98371 -8.25387 20.5209 -1340 4 21.8866 7.2843 18.6392 14.3432 0.686453 4.84686 -1341 6 12.8601 6.85899 39.0577 6.92589 -13.3495 -12.6124 -1342 4 12.2887 7.60854 39.1608 -14.8411 14.7282 0.271429 -1343 4 13.3423 6.79713 39.8797 5.00888 -0.905409 12.2129 -1344 6 10.1643 2.40912 23.2548 -13.4149 21.1074 -1.06732 -1345 4 10.2774 2.03439 22.3894 8.18098 -13.9841 -15.6202 -1346 4 9.49692 3.09648 23.049 6.99386 -4.39158 13.7206 -1347 6 12.5495 20.2147 19.5723 7.26787 8.21028 -18.3895 -1348 4 11.6895 19.7983 19.735 -1.5185 0.18686 -8.43892 -1349 4 12.6119 20.404 18.6017 -2.05058 -6.51038 26.2392 -1350 6 53.8702 6.35891 18.9198 29.7306 -6.18586 8.10346 -1351 4 53.0457 6.06715 19.2818 -21.258 -2.7468 0.110915 -1352 4 54.4788 6.08079 19.6257 -1.29631 10.1734 -11.3531 -1353 6 1.76233 4.00968 13.2412 15.2049 -20.178 -6.82767 -1354 4 1.1126 4.5015 13.7221 -14.7745 7.27862 5.55391 -1355 4 1.46634 3.0803 13.3195 6.22895 8.64986 -3.00031 -1356 6 2.68809 16.4658 4.58471 15.0105 -8.44828 17.4213 -1357 4 3.47968 16.3912 5.17607 -18.0483 5.65918 -16.5792 -1358 4 2.952 17.0668 3.88721 1.61121 4.43717 -9.18758 -1359 6 22.6412 7.38905 35.0491 -42.342 -19.7774 -51.2585 -1360 4 21.8701 7.10292 34.411 47.7649 22.3984 34.2121 -1361 4 22.4927 6.7758 35.7601 0.300803 -9.30322 17.5195 -1362 6 30.6449 27.8966 19.9 11.2186 24.5725 -17.4668 -1363 4 31.067 28.6028 19.3405 -15.311 -24.4133 12.7333 -1364 4 30.0502 27.364 19.3383 6.18265 4.0422 4.40167 -1365 6 18.3584 9.54031 6.21119 11.0026 -3.68808 23.2716 -1366 4 18.3645 9.12256 5.3612 -2.33489 -5.22153 -19.3682 -1367 4 19.1216 9.13552 6.66909 -8.40358 6.03455 -2.63927 -1368 6 21.0207 30.3946 30.8361 -20.2261 -14.3153 8.76877 -1369 4 21.7305 31.0371 30.8947 0.539155 4.23503 10.2216 -1370 4 20.6128 30.1908 31.727 18.9681 11.2591 -24.4987 -1371 6 28.3223 4.36971 15.0862 0.785553 22.566 1.53388 -1372 4 27.9162 3.53142 15.2341 -13.4814 -22.4749 6.99245 -1373 4 29.0547 4.16931 14.5133 14.7433 -0.183871 -4.75122 -1374 6 12.7699 0.652736 16.5284 -10.9622 36.0111 -3.70833 -1375 4 13.1417 1.43405 17.0195 -7.22472 -23.339 -11.6266 -1376 4 12.1312 1.03058 15.8629 17.1298 -5.78525 17.4901 -1377 6 27.5613 35.204 8.24204 -17.5468 -3.17574 2.50179 -1378 4 28.0037 35.3359 7.41158 3.58667 2.22765 -10.9792 -1379 4 26.8513 34.5538 8.04841 12.0719 12.2779 8.55847 -1380 6 24.0727 5.16129 41.0114 25.3265 34.0312 4.62534 -1381 4 24.5764 6.00631 41.0278 8.83913 -22.6202 16.662 -1382 4 23.4512 5.41721 40.3589 -27.9927 -11.5371 -21.4854 -1383 6 16.8577 24.9409 28.3044 -13.362 20.9446 -8.34262 -1384 4 15.8529 24.9248 28.4711 42.0709 9.51562 -15.4474 -1385 4 17.0929 25.6637 27.6385 -20.1406 -20.6283 22.1367 -1386 6 20.8367 12.7872 17.016 48.1357 -13.7972 -0.957512 -1387 4 20.9831 13.7012 17.3244 -4.24853 -6.44611 -2.53838 -1388 4 21.7731 12.3998 16.8344 -46.2893 13.5674 8.59046 -1389 6 35.7698 23.0286 30.9167 1.31549 -8.15919 10.0357 -1390 4 34.8007 23.0783 30.9694 4.38358 -0.634017 0.107585 -1391 4 36.0504 22.6611 31.7855 -2.79806 7.45108 -14.1947 -1392 6 36.3049 21.4 25.8723 16.8231 15.2703 -10.059 -1393 4 35.3849 21.2313 25.7163 -23.5769 -6.11261 -4.10927 -1394 4 36.6855 20.6326 26.2849 5.24534 -13.4215 6.45433 -1395 6 13.4896 6.74946 5.28081 -28.3592 57.2786 25.4238 -1396 4 13.8414 6.02988 4.86679 44.4058 -71.9847 -33.7479 -1397 4 12.7199 6.9047 4.75258 -19.8414 9.95147 -1.72496 -1398 6 20.8046 20.4221 13.7595 5.24729 11.8597 -23.4966 -1399 4 21.3314 20.3763 14.5586 1.04488 -1.4591 8.76088 -1400 4 19.8874 20.2651 13.9627 -8.54986 -4.70556 7.47732 -1401 6 20.3763 29.1306 1.39291 -22.654 9.61717 24.1604 -1402 4 20.4714 29.8874 2.01179 2.99602 -8.49852 -9.62387 -1403 4 19.4639 28.7985 1.61052 22.0838 3.18086 -13.1329 -1404 6 50.878 13.1268 37.2744 -6.92527 18.9089 19.2141 -1405 4 51.431 12.5903 37.8743 -5.40112 9.96959 -2.47836 -1406 4 50.5327 13.8902 37.8162 10.8793 -23.2499 -13.6212 -1407 6 33.933 34.1706 20.4988 -24.935 23.2996 -4.02345 -1408 4 33.9537 34.3969 19.5503 3.97405 -5.2202 10.173 -1409 4 33.1424 34.6907 20.8306 20.6842 -17.0796 -4.50693 -1410 6 26.2139 28.0427 27.5441 -18.3219 -6.87449 2.92541 -1411 4 26.6233 28.4264 28.3298 2.52406 0.509022 -5.28732 -1412 4 25.2474 28.0355 27.7473 15.6982 -2.70826 -9.65401 -1413 6 7.68199 21.3044 4.2899 -23.4352 7.97399 30.3744 -1414 4 8.39223 20.9571 3.80392 40.3202 -21.1106 -20.5498 -1415 4 7.23721 21.8696 3.67656 -12.7303 12.1883 -10.427 -1416 6 21.997 15.1678 5.91921 0.156106 10.1967 -8.47357 -1417 4 22.4631 15.3078 5.09012 1.49736 10.8302 -2.43488 -1418 4 21.9323 14.2285 5.99467 -4.63281 -19.7734 10.7123 -1419 6 21.7161 24.0028 3.81129 14.7157 -6.77156 -2.79544 -1420 4 22.6514 24.278 3.99089 -16.266 -7.57571 -5.80044 -1421 4 21.7278 23.1773 3.27349 4.3704 10.7286 8.25651 -1422 6 11.5654 23.7677 12.5675 4.34126 23.9889 5.0328 -1423 4 11.8179 24.711 12.3772 -5.51197 -27.812 -0.203907 -1424 4 11.194 23.7871 13.4529 -2.51135 -1.17837 2.27349 -1425 6 32.365 18.0609 29.8133 5.42876 1.07285 10.0727 -1426 4 33.2855 17.8495 29.9872 2.18588 2.92383 8.75228 -1427 4 32.2516 17.686 28.9464 -9.45666 -7.03173 -17.6671 -1428 6 9.26057 12.3901 30.3108 6.69251 -5.93803 -6.45383 -1429 4 8.9331 13.0089 30.9751 -1.99931 -0.452864 0.983921 -1430 4 10.127 12.0766 30.6488 -15.6011 7.03664 -5.16285 -1431 6 40.1575 25.9297 9.14135 -21.3024 -7.39617 3.31146 -1432 4 40.7828 25.2448 9.36979 6.64832 -8.60816 0.262948 -1433 4 40.6901 26.6937 8.96671 10.3695 18.4246 -3.8085 -1434 6 43.1786 32.337 37.3292 -33.551 -18.2832 -9.28851 -1435 4 42.7165 32.8749 36.6701 14.8891 8.67062 4.46068 -1436 4 42.4294 31.7351 37.5575 24.0939 3.67107 5.33039 -1437 6 44.0961 6.28371 31.2632 9.51948 -8.69332 -33.5784 -1438 4 43.4914 6.92213 31.6058 -15.4833 19.2503 12.9198 -1439 4 44.559 5.89005 31.9835 8.76633 -8.79917 23.1113 -1440 6 10.2083 18.8859 19.6919 15.5822 -2.80816 -8.35433 -1441 4 10.2079 18.3466 20.4907 -1.18434 0.124911 0.125127 -1442 4 9.35433 19.315 19.665 -12.7717 3.54701 3.24565 -1443 6 7.05259 15.5816 15.0277 -11.6868 16.7681 -20.4125 -1444 4 7.21112 15.523 14.0697 -0.749561 -1.2692 3.08306 -1445 4 7.39122 14.7797 15.3874 7.84577 -24.8334 9.86289 -1446 6 24.5366 3.48359 27.8583 16.7503 5.69766 5.18976 -1447 4 23.7024 3.43271 28.3539 -4.73503 -2.50774 -10.2909 -1448 4 24.4259 3.10654 26.9763 -12.6917 -5.22111 2.5626 -1449 6 54.3931 31.8073 9.72289 -3.19054 17.1237 19.0803 -1450 4 53.9641 31.62 8.89214 -6.37727 -2.00813 -13.4715 -1451 4 54.1243 32.7301 9.92854 3.65429 -15.124 -2.64791 -1452 6 6.79493 17.0949 36.2025 -8.81624 7.47492 14.5397 -1453 4 5.9165 16.6466 36.2092 18.1356 5.91394 -12.2869 -1454 4 7.21103 17.1598 35.3293 -13.3551 -7.88765 -1.67162 -1455 6 28.633 7.46221 20.4165 -21.0133 14.9556 -29.8407 -1456 4 27.7506 7.6389 20.7846 4.83271 -6.12746 3.71795 -1457 4 28.5316 7.77661 19.4783 9.56717 -7.40103 22.9991 -1458 6 17.0376 1.7027 8.35788 5.34968 28.5352 32.0038 -1459 4 17.0661 0.753124 8.28199 -2.4228 -14.8367 -20.8379 -1460 4 16.762 2.22772 7.59129 -1.56258 -15.3605 -8.12812 -1461 6 19.1384 19.3343 35.5751 19.5023 3.30605 7.15282 -1462 4 18.4451 18.7061 35.4179 -10.2251 -8.92118 -4.92207 -1463 4 19.8852 18.808 35.914 -3.54436 4.66685 -0.605832 -1464 6 7.31639 31.3666 13.5695 -43.9944 -20.214 -21.2721 -1465 4 6.78612 30.574 13.8569 21.4883 17.7075 -0.698983 -1466 4 6.68503 31.7843 12.9295 22.0056 -0.349161 9.64417 -1467 6 16.674 5.24419 12.8556 -11.0373 -33.5815 5.02698 -1468 4 17.465 5.75961 12.9546 20.2971 3.5869 6.63236 -1469 4 16.7677 4.34295 13.2785 1.53127 21.9447 -10.2143 -1470 6 43.8803 12.7494 34.5747 -22.4085 -20.9808 -0.0671255 -1471 4 43.9515 13.6536 34.2548 -4.30422 8.76569 -3.51904 -1472 4 42.9542 12.429 34.42 18.6754 8.57765 -0.433924 -1473 6 42.6607 36.4569 28.5239 -16.8168 -12.4187 2.20896 -1474 4 42.172 37.2929 28.6321 13.9601 -3.78206 -4.91178 -1475 4 43.5913 36.5775 28.2923 4.62592 13.2896 -0.105187 -1476 6 35.3772 15.0586 6.04009 27.912 48.9275 -7.18458 -1477 4 35.887 15.8982 5.7897 -19.1126 -32.2788 12.1212 -1478 4 34.8045 14.9281 5.27735 -5.52923 -7.04807 -1.55591 -1479 6 19.4078 5.85855 6.1829 -40.2001 -18.9085 -3.31614 -1480 4 18.5441 5.99364 6.63156 8.43156 -9.10613 -8.3884 -1481 4 19.928 6.53616 6.54489 31.8426 31.4232 15.0663 -1482 6 29.261 38.1682 6.98131 -37.2303 32.1811 -6.57247 -1483 4 28.4837 38.0966 7.57517 15.5489 -1.40449 -6.41795 -1484 4 29.8842 37.5088 7.21603 19.671 -25.1607 10.5683 -1485 6 19.357 26.1782 8.47801 4.74765 -18.9961 17.9486 -1486 4 19.3733 25.7814 9.38274 -2.97831 10.6699 -17.265 -1487 4 20.1618 25.7953 8.09114 -4.76457 3.34604 0.730176 -1488 6 4.92328 16.6713 6.1398 7.47336 5.27851 2.26954 -1489 4 5.50113 17.3858 5.8203 -2.76896 -2.40075 1.51866 -1490 4 5.42288 15.8417 6.02573 -4.96937 12.5626 -0.560722 -1491 6 6.06184 16.6875 28.0703 25.9558 6.64688 1.10321 -1492 4 5.15824 16.4097 27.9597 -16.212 -5.66481 -14.185 -1493 4 6.48748 16.8231 27.1848 -21.9791 -6.00697 19.2504 -1494 6 21.7362 29.3702 22.1089 -17.2737 20.913 34.8846 -1495 4 21.4452 30.3289 22.1112 6.19611 -27.0689 0.469942 -1496 4 21.3293 28.9728 22.9428 14.5469 12.9694 -26.9427 -1497 6 24.4985 0.540505 12.8515 12.2489 -9.36427 2.95715 -1498 4 24.0437 0.939092 12.114 -3.50986 5.42614 -10.4761 -1499 4 24.1106 0.99496 13.5957 -0.561841 3.41965 12.163 -1500 6 18.4019 28.2584 40.3145 -11.401 19.5033 -15.6681 -1501 4 18.3886 27.6361 41.0165 -1.05122 -20.6036 22.2694 -1502 4 19.1831 28.024 39.826 8.23901 2.08545 -8.43276 -1503 6 10.3826 17.4565 21.9113 1.92941 -13.2413 3.45357 -1504 4 9.8824 16.6205 21.8349 3.82121 7.52813 2.02092 -1505 4 9.93899 17.9725 22.5913 -5.82795 2.16988 4.16556 -1506 6 13.5489 13.3588 39.6353 11.9209 29.8927 39.0415 -1507 4 13.8427 14.2544 39.3649 -8.64321 -16.3346 -3.85104 -1508 4 13.5548 13.4385 40.6332 -1.97454 -11.1079 -31.9482 -1509 6 19.5449 26.0093 24.7389 -52.2633 13.2593 -7.73686 -1510 4 19.57 25.3975 24.0097 10.2262 -10.7296 -10.4349 -1511 4 20.3304 26.0184 25.2393 35.6126 -10.3894 17.1361 -1512 6 8.93096 25.8929 20.0882 -7.71251 -64.4566 3.30388 -1513 4 8.30787 26.3938 20.5887 -11.4685 32.8171 11.63 -1514 4 9.62246 26.3511 19.648 20.7791 34.2926 -13.3665 -1515 6 13.4555 41.2072 30.5108 -10.8988 -15.928 5.69795 -1516 4 14.2767 41.1294 31.0436 -12.4449 -5.39064 -3.38157 -1517 4 12.7718 40.5451 30.8276 25.6688 18.9533 -5.69319 -1518 6 21.165 21.6707 11.1126 6.53241 11.8742 3.94385 -1519 4 20.8889 20.8699 10.6872 -6.5221 -17.8932 -11.6656 -1520 4 21.171 21.4318 12.0451 -0.673303 -0.892159 6.0991 -1521 6 43.5659 10.3222 15.565 -2.18625 -17.2881 -4.53442 -1522 4 43.269 9.50121 15.139 10.696 3.36153 7.59808 -1523 4 42.8911 10.937 15.2983 -10.0921 17.3133 -0.93945 -1524 6 23.5255 5.06673 12.3063 -8.27451 55.1521 -7.02327 -1525 4 23.4703 4.15364 12.096 -5.93718 -33.8878 -14.7403 -1526 4 23.077 5.57318 11.5535 15.1023 -26.9196 22.8331 -1527 6 9.29314 15.4001 4.25145 -3.86255 -4.02248 -25.5662 -1528 4 8.9509 16.1187 4.78154 1.1615 8.22379 13.6068 -1529 4 9.97933 14.9549 4.74249 8.84801 0.0887981 11.7331 -1530 6 26.7067 10.8779 17.5788 3.55047 -19.7627 -22.9275 -1531 4 26.5537 10.995 18.4988 -3.13636 8.79354 30.8805 -1532 4 26.79 11.729 17.1566 -1.16375 6.51516 1.16674 -1533 6 26.0497 23.6027 33.6801 19.5894 25.2732 20.1931 -1534 4 25.4452 23.9936 33.0304 1.52608 5.68176 -1.06817 -1535 4 26.6384 24.3139 34.1277 -30.0139 -24.8801 -23.6693 -1536 6 7.5709 10.5028 28.9083 -0.962228 -19.583 -21.6711 -1537 4 6.74329 10.4799 29.4005 3.80738 8.46019 8.36633 -1538 4 8.19878 11.0832 29.3397 0.629116 8.24646 12.7121 -1539 6 16.498 16.9072 24.6485 7.82025 23.6222 16.3151 -1540 4 16.0345 17.7596 24.5588 5.31695 -3.73313 -0.390286 -1541 4 16.1792 16.4208 23.9083 -7.11448 -16.9587 -21.9433 -1542 6 12.549 12.7866 0.448591 8.35618 6.39845 34.9671 -1543 4 12.9768 12.9146 1.38779 -15.5602 -17.6496 -50.0052 -1544 4 12.7689 11.9205 0.0349689 0.659473 7.36742 13.3893 -1545 6 6.80731 2.45617 9.05869 -7.23501 -7.03372 -0.578084 -1546 4 7.10343 3.02287 9.78944 7.77528 -6.31722 -2.26682 -1547 4 7.3272 1.63733 8.99034 2.01029 5.74015 6.94656 -1548 6 28.8877 11.8706 12.0154 41.6386 34.6329 -2.99516 -1549 4 28.2108 12.4771 11.6895 -6.34049 1.49886 1.56166 -1550 4 29.7533 12.3393 11.8008 -29.7579 -18.4108 8.17464 -1551 6 44.6745 32.5962 29.7139 -34.2161 4.66467 6.73964 -1552 4 43.7628 32.9784 29.4642 35.9402 -16.1761 10.2258 -1553 4 44.5125 31.9002 30.3967 -1.3182 18.2082 -15.8911 -1554 6 28.5995 15.1068 32.2872 13.2766 -51.3111 -20.1848 -1555 4 29.0279 15.8582 31.8991 2.31019 19.0875 -3.40369 -1556 4 29.0943 14.3419 31.8537 -21.7517 23.8731 20.1718 -1557 6 1.14062 22.1898 33.6289 -39.3586 14.574 19.5436 -1558 4 0.65227 22.798 33.0535 3.91391 -2.7929 6.08546 -1559 4 1.82717 21.8879 33.088 34.4042 -16.5957 -27.8984 -1560 6 17.4513 16.8201 9.93098 -1.82085 -23.3459 26.2514 -1561 4 17.8906 17.1746 9.18159 7.86355 15.3521 -22.135 -1562 4 18.0267 16.0779 10.2085 -7.73246 7.19916 -1.96586 -1563 6 18.7435 29.8048 14.4095 21.7061 -3.72347 40.0221 -1564 4 19.5652 29.5706 14.9087 -19.4331 3.67999 -8.42588 -1565 4 18.9661 29.6909 13.4944 1.97037 -1.23698 -19.2163 -1566 6 39.4071 6.51101 13.0179 12.0574 6.81682 -11.0022 -1567 4 39.7785 7.30288 12.5709 -10.193 -11.7897 7.6563 -1568 4 39.9532 5.78104 12.6849 -4.03584 4.98089 5.48617 -1569 6 54.0977 38.2821 14.3159 8.76467 -13.509 23.2458 -1570 4 53.5116 38.6447 15.0061 0.0542658 1.01747 -18.4972 -1571 4 53.8554 38.6311 13.4594 -12.9742 11.219 -5.93773 -1572 6 7.52036 32.013 20.9427 34.362 14.2167 21.5407 -1573 4 7.05735 31.9924 20.1252 -18.8869 -6.37038 -21.2822 -1574 4 7.04171 31.4816 21.5607 -16.1882 -11.3569 11.099 -1575 6 26.965 15.5039 13.8257 -10.8147 -22.3452 14.7237 -1576 4 27.2177 14.7358 14.3683 8.65177 6.42067 -5.59001 -1577 4 26.0429 15.6169 14.0906 -6.80859 9.66341 -6.51148 -1578 6 18.3782 16.4473 32.1249 -4.95226 -1.86998 -9.87987 -1579 4 18.1426 16.6374 31.1969 4.73263 -0.719504 8.39792 -1580 4 19.0836 17.0573 32.3614 6.73072 6.57595 -2.73442 -1581 6 52.4873 31.678 23.2415 -44.1119 -6.58328 47.4356 -1582 4 52.4708 32.2686 24.0415 7.23299 -8.75358 -21.8316 -1583 4 53.1739 31.883 22.645 31.3465 14.6123 -23.9869 -1584 6 2.16824 9.71317 28.2162 5.46837 -18.1801 7.45826 -1585 4 2.48183 10.5213 27.7929 -7.61484 8.72751 3.65687 -1586 4 1.37959 9.87032 28.768 3.44281 10.2362 -4.06622 -1587 6 32.9194 0.0905733 22.5781 10.5432 -20.5017 -7.42813 -1588 4 33.2395 41.1185 22.3208 -17.3926 6.61176 1.08087 -1589 4 33.7441 0.505918 22.8191 5.29332 16.1982 3.6992 -1590 6 20.7309 41.5697 38.6372 28.3147 -14.9122 -44.687 -1591 4 20.0328 41.0591 39.0281 -13.7779 -1.58578 11.2509 -1592 4 21.0348 40.9602 37.8857 -7.98591 29.4899 32.1121 -1593 6 43.3035 24.332 12.1458 11.7575 -1.61212 -4.71191 -1594 4 43.2118 25.2792 12.3722 8.64503 -11.1136 -9.01316 -1595 4 44.1249 24.1975 11.6011 -17.6772 13.9566 14.4164 -1596 6 22.028 36.2965 11.8178 -12.5217 11.0116 -6.64335 -1597 4 21.6755 36.9888 11.229 7.35556 -7.61462 10.605 -1598 4 22.8593 36.0261 11.4203 4.02803 -2.23458 -0.408194 -1599 6 50.7458 20.5312 30.3336 -27.3371 19.0798 0.575242 -1600 4 50.2829 20.0188 31.024 4.3389 0.549123 -5.17754 -1601 4 50.1148 21.2814 30.1453 20.3707 -20.1638 4.65154 -1602 6 20.8352 3.85006 18.1924 -4.58005 6.82859 16.651 -1603 4 21.6331 4.17131 17.7775 4.55578 1.29171 -4.07778 -1604 4 20.7516 4.34878 19.0287 -0.852135 -6.30171 -7.97465 -1605 6 4.00732 20.6422 6.98905 -51.5603 -31.2986 19.6291 -1606 4 3.1116 20.4695 6.56725 35.2765 12.481 -1.34365 -1607 4 3.83148 20.2497 7.8921 17.5771 16.9916 -21.2359 -1608 6 11.9503 15.4361 41.4392 2.8915 -19.3712 8.63656 -1609 4 11.9967 14.4718 41.7234 3.98465 29.7679 -14.4511 -1610 4 12.4631 15.5787 40.6176 -3.08486 -9.43894 7.49139 -1611 6 3.00006 18.5443 38.9307 7.29951 -23.84 25.6029 -1612 4 3.57591 17.7463 38.8471 -9.50595 12.5214 2.28144 -1613 4 2.93408 18.9335 38.0756 -3.85177 13.2219 -26.1975 -1614 6 8.60604 38.8696 11.3027 41.4164 30.2615 0.48057 -1615 4 9.41419 39.0226 10.7506 -16.8144 -5.25469 8.62565 -1616 4 8.21901 38.0768 10.9944 -17.9318 -38.1368 -15.4555 -1617 6 12.9777 33.9736 38.4849 13.2116 9.7409 3.49313 -1618 4 12.6169 33.1824 38.0476 12.8065 1.18326 0.516457 -1619 4 13.9558 34.0654 38.367 -20.6967 -9.66923 -0.235313 -1620 6 4.68265 11.9882 6.05233 -5.36104 -17.6375 -21.4001 -1621 4 3.82121 11.6194 5.80881 -7.3972 4.97776 10.103 -1622 4 5.22981 11.6659 5.30604 -0.806592 6.4598 12.5779 -1623 6 10.8388 15.9226 25.2234 -25.8257 0.885817 -3.68505 -1624 4 11.7194 16.2357 25.361 23.5714 9.8582 3.12124 -1625 4 10.3656 16.637 24.773 5.49819 -5.38784 0.449897 -1626 6 20.7519 3.25216 6.54608 14.2232 16.6176 4.63006 -1627 4 20.286 2.47445 6.25961 -10.3965 -11.4853 -2.16446 -1628 4 20.1859 4.03183 6.47283 -6.25253 -2.40724 -3.99784 -1629 6 47.6296 39.155 31.2075 -6.94169 16.2372 -29.2685 -1630 4 46.6717 39.1522 30.9686 19.778 5.05469 4.61154 -1631 4 48.0746 39.7923 30.5789 -18.3255 -25.0069 20.1215 -1632 6 8.32942 27.7692 27.6861 -22.9675 10.5768 13.2964 -1633 4 7.92083 27.0814 28.2574 8.55111 11.2092 -8.24047 -1634 4 9.05389 27.3382 27.2479 10.5137 -11.4359 -5.41666 -1635 6 33.26 40.3166 33.4176 17.9089 -0.14465 -4.13778 -1636 4 32.5337 40.9457 33.2593 10.2249 -4.59604 -5.86803 -1637 4 34.0027 40.4737 32.781 -17.2015 3.54767 8.86095 -1638 6 24.5063 34.6298 27.2698 0.491312 8.45089 -9.78892 -1639 4 24.8706 35.531 27.0561 -9.74802 -22.5685 0.190878 -1640 4 24.1 34.2837 26.4337 10.8101 11.1551 19.1745 -1641 6 13.3248 36.7606 35.7302 31.7841 1.54421 8.12469 -1642 4 14.2215 36.6075 36.119 -13.0291 10.9369 -8.07597 -1643 4 12.8242 36.0333 36.0767 -19.6956 -11.898 1.78685 -1644 6 34.0654 20.1519 33.2169 18.328 45.6356 -7.38724 -1645 4 34.7846 20.5927 32.7056 -13.2567 -20.8909 7.62801 -1646 4 33.6055 20.9496 33.5712 -4.62613 -21.3045 2.82084 -1647 6 22.8301 33.56 31.6141 4.86266 11.3389 -12.2002 -1648 4 23.5774 34.1707 31.5466 -2.83601 4.36281 -5.03091 -1649 4 23.1188 32.9172 32.2538 0.234413 -13.6868 11.6365 -1650 6 23.7437 2.42751 19.8437 5.37542 22.288 12.015 -1651 4 24.549 1.92657 19.7151 11.8542 -9.34304 -3.08207 -1652 4 23.0522 1.96699 19.3939 -17.1839 -15.7883 -12.7178 -1653 6 10.5922 1.64055 20.5239 -11.6119 -4.18685 -4.47424 -1654 4 10.0475 0.976152 20.0603 6.63037 0.339841 6.84259 -1655 4 10.5 2.45781 20.009 1.22375 1.55874 1.33627 -1656 6 6.49834 24.8637 7.80908 13.1619 -16.462 -27.2261 -1657 4 7.39752 24.8711 7.42138 -7.39511 8.18905 12.026 -1658 4 6.07255 24.1767 7.26903 -7.5733 6.7583 6.8074 -1659 6 54.7892 32.5297 25.4757 -1.36407 18.5665 -18.8778 -1660 4 54.0312 33.1434 25.3693 10.0694 -13.7478 6.1371 -1661 4 0.333918 32.6202 24.6425 -12.8409 -6.42816 22.883 -1662 6 6.2467 20.1884 28.9797 -14.5872 3.94595 -2.55046 -1663 4 5.42154 20.1642 28.4577 8.07739 1.90281 8.6477 -1664 4 6.84484 19.6236 28.4838 10.3646 -4.74821 0.341067 -1665 6 50.0565 21.6117 11.3373 -2.04109 28.5423 -29.4123 -1666 4 50.95 21.7264 10.9878 2.40449 3.31798 -5.14809 -1667 4 50.1463 20.9073 11.9368 0.900865 -33.3483 27.1981 -1668 6 43.4794 33.5181 19.6392 10.2306 -3.22473 -8.26676 -1669 4 43.7308 33.5714 20.5426 20.9097 -0.172793 18.6354 -1670 4 42.5556 33.6283 19.7345 -31.1875 3.87355 -8.92325 -1671 6 30.8203 7.18413 41.0653 -47.5647 29.7584 13.5959 -1672 4 29.9879 7.63165 40.681 33.629 -21.8567 10.9994 -1673 4 30.7637 7.50249 0.10761 7.36747 -14.0232 -31.1296 -1674 6 12.1328 25.8622 11.0863 -33.3162 -17.1307 -4.35232 -1675 4 11.2035 26.0164 10.7385 31.652 5.74526 10.6132 -1676 4 12.7063 26.6022 10.9281 7.22016 21.1466 -6.88425 -1677 6 47.8272 5.81934 17.7377 34.4122 -10.5063 -19.6374 -1678 4 48.0885 5.28838 16.9377 -7.84164 17.03 17.5567 -1679 4 48.6906 6.1712 18.0872 -20.5621 -5.0871 -4.09565 -1680 6 35.1646 12.9005 16.5891 -8.94037 2.15609 -8.82704 -1681 4 35.428 13.0005 17.5199 -6.39768 8.78744 -5.13392 -1682 4 34.5308 13.6301 16.3523 17.2323 -15.7422 12.9621 -1683 6 10.4611 10.6156 33.9687 -31.8989 -9.58391 14.7288 -1684 4 10.7981 11.3375 34.5166 5.24051 -2.75865 -7.26377 -1685 4 9.62118 10.4004 34.4306 17.5569 -1.50819 -12.473 -1686 6 9.86916 7.4616 9.67483 -1.17411 0.415312 -19.5192 -1687 4 9.17172 8.12646 9.7346 0.921409 2.8109 10.1471 -1688 4 9.97058 7.3459 8.70248 1.1017 -0.154201 19.4763 -1689 6 11.1489 9.5612 29.1408 -3.50418 -13.4139 2.93109 -1690 4 10.6848 9.26325 29.9428 4.68224 5.10434 -5.79998 -1691 4 11.3989 8.73954 28.6776 0.998479 5.88331 1.3781 -1692 6 46.4028 12.7539 37.8993 8.34964 0.221 -8.93676 -1693 4 46.6625 12.9969 36.9769 -3.46511 -1.57209 17.4302 -1694 4 46.8246 13.3669 38.5286 -1.63466 -3.53539 -5.22058 -1695 6 4.76485 19.028 16.0085 -13.5875 12.8334 -9.71245 -1696 4 4.2246 19.0797 16.8211 14.4547 -7.44532 -2.23877 -1697 4 5.5965 18.5831 16.2078 1.83868 -2.3176 10.3072 -1698 6 50.2593 39.8135 19.3633 -11.209 7.32279 -16.1387 -1699 4 50.2357 39.0929 20.0186 -9.83071 -0.813057 -10.1916 -1700 4 49.5811 39.7404 18.6324 20.3589 -6.83946 23.6454 -1701 6 3.57863 23.2976 26.309 -19.8478 3.89203 -2.42552 -1702 4 2.95325 23.1663 25.5593 11.1236 -1.69658 12.5574 -1703 4 3.09228 23.9147 26.9028 8.7219 -10.8877 -9.85517 -1704 6 43.325 18.2347 20.509 -6.81505 -1.42332 -3.46621 -1705 4 42.8171 19.0284 20.7204 1.20306 1.51529 1.23812 -1706 4 43.8577 18.0426 21.2915 2.12676 -2.58083 4.4502 -1707 6 14.5031 41.5275 19.7277 -3.40329 -5.13047 -40.8094 -1708 4 13.9246 41.7804 20.437 0.184992 5.83632 25.1113 -1709 4 15.42 41.4218 19.9774 10.3149 -1.62678 14.571 -1710 6 29.2836 29.8681 26.9083 14.7251 3.00272 -32.0725 -1711 4 29.2754 29.741 25.8744 6.18055 14.2787 56.2455 -1712 4 30.1283 30.2623 27.2985 -22.384 -15.5718 -22.4063 -1713 6 6.3217 26.153 11.5726 -10.9318 2.11689 -6.65038 -1714 4 6.21736 25.7454 12.4421 7.16784 6.77942 9.71283 -1715 4 6.96084 26.8819 11.5675 -0.124344 -5.20772 8.78036 -1716 6 27.6636 9.22988 15.2432 27.2347 15.0341 -6.49447 -1717 4 28.4103 9.83484 14.9873 -20.1055 -14.3916 8.85848 -1718 4 27.7674 8.48088 14.6445 -1.45999 -3.40178 1.02673 -1719 6 29.7804 38.0662 17.0819 -1.94795 -3.59677 -9.66723 -1720 4 29.6031 37.2203 16.6025 -2.55573 18.1678 4.54076 -1721 4 29.1155 38.7497 16.8561 3.55432 -16.3657 1.57327 -1722 6 52.2257 28.7184 4.26028 43.5541 11.735 -13.9492 -1723 4 53.1498 28.7813 3.86382 -28.9168 1.3453 15.0129 -1724 4 51.9642 27.8111 4.13511 -4.98861 -18.1961 -3.0857 -1725 6 17.1716 16.6708 6.09349 0.800403 22.8617 11.3476 -1726 4 16.9906 17.4665 6.64994 5.32834 -8.85643 -15.9231 -1727 4 16.9912 15.9587 6.69883 -0.0606397 -19.1034 5.18453 -1728 6 36.6551 7.54529 33.4256 0.520164 -21.8515 26.6937 -1729 4 35.9994 7.02185 33.9501 8.71508 10.7979 -12.9224 -1730 4 36.139 7.85703 32.6949 -12.9525 8.58568 -17.7829 -1731 6 26.1712 3.13186 9.59195 18.1066 21.2961 -28.5304 -1732 4 26.5502 3.5196 10.357 16.0028 12.4994 23.003 -1733 4 25.6506 2.45477 9.93435 -32.3265 -38.1289 14.2303 -1734 6 1.19956 17.1196 33.1708 -2.2935 18.3305 -9.07621 -1735 4 1.01553 17.8006 32.4822 1.56489 -10.8534 12.1427 -1736 4 0.844206 17.4429 34.0214 2.04572 -1.59411 -6.06332 -1737 6 29.1739 10.178 5.37516 -2.40587 -18.3881 11.7134 -1738 4 28.5386 10.354 6.08377 0.376669 4.93981 -3.98875 -1739 4 29.4881 9.26834 5.54278 -5.29161 7.67482 -7.40705 -1740 6 9.22817 21.1342 0.188585 30.2393 3.90367 9.01386 -1741 4 10.0008 20.6689 41.6954 -19.6386 2.89796 1.05729 -1742 4 8.40981 20.8027 41.7407 -2.68979 -7.66638 -7.21336 -1743 6 7.42006 26.8879 34.8536 3.14545 16.5486 30.4349 -1744 4 7.04622 27.0927 35.7464 10.1233 -6.04195 -26.4158 -1745 4 6.87255 26.19 34.5186 -13.4343 -18.5802 -10.0193 -1746 6 18.6153 10.1647 3.02259 -21.2705 37.3854 6.86975 -1747 4 17.9982 9.42011 2.89287 2.11135 15.8633 3.52195 -1748 4 18.115 11.0437 3.25865 19.508 -44.5053 -11.6159 -1749 6 13.1266 21.2208 25.207 -7.78894 4.80204 -7.88194 -1750 4 12.927 21.6586 24.3646 3.95449 -7.72121 4.87382 -1751 4 12.8054 20.3208 25.1571 -2.69895 -8.80511 -3.48609 -1752 6 4.90585 24.4116 40.531 -24.4864 -14.2944 -35.1794 -1753 4 5.64285 24.6041 41.0938 21.6142 3.21823 7.1591 -1754 4 5.22115 23.997 39.6806 -3.1008 12.4445 27.1665 -1755 6 54.7234 6.29054 9.93868 16.9838 3.76988 -11.4262 -1756 4 54.1595 6.0167 10.6465 -16.0707 -8.53288 16.3243 -1757 4 -0.00708757 7.17696 10.1972 2.88265 8.42125 0.296955 -1758 6 51.7481 16.6603 19.3703 -0.380283 5.87397 -29.4424 -1759 4 51.6376 16.2748 18.4816 -6.94363 -1.60509 11.109 -1760 4 52.3909 17.3585 19.2003 6.35466 6.30558 5.78841 -1761 6 38.6244 2.9738 13.1093 11.8256 2.30897 44.7329 -1762 4 38.5518 3.44318 13.9917 -0.399232 -9.9856 -23.4333 -1763 4 38.2423 3.54447 12.4592 -11.1085 17.5319 -17.0773 -1764 6 19.4422 35.7095 9.59568 3.40577 -0.828385 -4.73593 -1765 4 18.7414 36.105 9.07989 -9.16576 -3.00828 -7.06541 -1766 4 19.0009 35.4265 10.4088 3.97598 4.46758 -4.25365 -1767 6 46.943 37.6271 25.6985 10.3793 1.77648 -5.56802 -1768 4 47.12 37.9785 24.823 -9.34628 8.6078 -10.4475 -1769 4 47.7536 37.1497 25.8683 2.27046 -5.59472 9.98269 -1770 6 20.0359 17.269 14.7493 3.99527 -1.04076 21.685 -1771 4 19.226 17.5112 15.2169 -1.54973 1.23777 -13.9596 -1772 4 20.6203 17.0021 15.471 1.89523 -0.789097 -10.2839 -1773 6 24.7462 29.2867 3.75843 -10.1451 -8.18783 10.4774 -1774 4 24.6712 28.3277 3.51733 13.2212 23.8029 -9.5704 -1775 4 25.3186 29.8222 3.19111 0.258423 -15.3949 -10.1904 -1776 6 3.43 8.91865 6.82525 30.9316 4.78471 42.1024 -1777 4 3.12906 8.84201 7.76799 3.51474 0.65101 -30.0512 -1778 4 4.4001 9.15772 6.93718 -35.8795 -6.21414 -10.2854 -1779 6 17.4867 30.5875 19.7089 25.363 -13.1809 -11.8275 -1780 4 18.4189 30.3609 19.3993 -33.7851 8.31766 10.936 -1781 4 16.9116 29.8624 19.4038 1.038 7.7974 -2.73085 -1782 6 13.2718 16.1862 39.0546 8.76191 -18.4723 6.03369 -1783 4 13.8233 16.8904 39.4031 3.30361 7.54485 1.72389 -1784 4 12.5422 16.5765 38.5789 -11.7633 13.4881 -8.40344 -1785 6 23.832 27.9756 11.5898 -7.03122 5.38421 -2.05105 -1786 4 23.0756 27.4469 11.9259 8.81977 12.3317 -3.01362 -1787 4 23.7182 28.9056 11.8688 -5.28793 -12.9553 -0.41204 -1788 6 14.4579 24.426 21.2343 -3.66896 12.863 -1.79834 -1789 4 13.9584 25.2806 21.2855 7.33453 -15.5065 2.73981 -1790 4 14.2661 23.9117 22.0367 -3.91682 9.90798 -0.991428 -1791 6 46.6073 15.1543 22.2965 -20.8333 -3.77381 -11.8272 -1792 4 45.9584 14.6421 21.811 -6.87655 -3.95362 10.1018 -1793 4 47.2458 15.2644 21.6001 24.1162 10.8017 0.759212 -1794 6 19.1409 29.7195 11.8497 24.0494 -34.2428 10.0272 -1795 4 18.8784 30.5975 11.5793 -19.1418 4.86007 -17.3781 -1796 4 18.6106 28.9994 11.4276 0.263541 23.8948 1.0376 -1797 6 36.9127 18.8084 27.6222 -22.9356 -21.6011 26.171 -1798 4 36.4352 18.471 26.8408 6.36827 4.7914 5.64024 -1799 4 36.536 18.2194 28.3533 14.6987 24.2872 -28.1415 -1800 6 35.8684 17.5378 25.4906 20.6945 -0.513689 -30.4481 -1801 4 36.5966 17.7728 24.866 -15.8574 8.27186 11.6809 -1802 4 35.9779 16.5759 25.48 -10.902 2.42848 10.2606 -1803 6 8.03691 41.9141 31.5248 13.0394 10.4535 -6.8036 -1804 4 8.57921 41.2412 31.9888 -13.1962 14.522 -11.1095 -1805 4 8.63283 0.684743 31.1326 -8.3799 -15.4286 7.32752 -1806 6 31.7059 34.8342 17.9371 1.99631 -25.0047 -8.79133 -1807 4 32.5911 34.4609 17.7211 -13.4776 12.334 6.09844 -1808 4 31.8527 35.7258 18.2497 13.1847 15.6537 3.27409 -1809 6 22.1093 41.055 5.1451 11.5479 29.9587 -53.8497 -1810 4 22.1004 40.5969 5.93279 -2.68624 -33.8843 55.363 -1811 4 22.7885 40.6204 4.60559 -4.38419 0.844423 3.37931 -1812 6 11.6153 5.16618 29.5584 -27.6475 13.1782 12.6346 -1813 4 12.1606 4.37097 29.6057 -8.91967 -2.9702 4.15115 -1814 4 10.7377 5.1092 30.0631 35.581 -10.2726 -16.0904 -1815 6 13.0239 9.45481 21.0754 -25.8377 -26.1508 -25.9824 -1816 4 13.6778 9.97234 21.4999 31.652 16.6928 15.5055 -1817 4 13.4195 8.72209 20.5617 -0.589626 12.3395 6.44381 -1818 6 12.4227 4.1736 0.163828 29.6522 45.8695 -12.8421 -1819 4 12.6651 3.77524 1.00427 0.341759 -1.42745 2.51987 -1820 4 13.0617 4.97102 0.020112 -31.9214 -41.0145 4.8633 -1821 6 45.168 14.6284 28.1023 4.783 -10.4532 13.0266 -1822 4 45.253 14.8969 27.1759 8.39119 -6.85383 -0.732919 -1823 4 45.9575 14.0916 28.3529 -13.3622 13.2892 -14.7888 -1824 6 52.571 19.2551 0.894665 -6.12931 -19.318 2.27414 -1825 4 52.6102 19.199 41.8388 0.592413 0.00811024 1.08479 -1826 4 52.8129 20.1442 1.11528 6.55776 18.4237 2.43046 -1827 6 0.161625 18.5694 30.5785 -3.0227 0.535636 4.36465 -1828 4 0.968981 18.7291 30.0798 6.18464 -7.16445 -2.53371 -1829 4 54.7907 19.4514 30.677 -10.8229 5.89199 6.00525 -1830 6 17.6528 28.1849 1.96402 -7.28907 9.7522 11.2687 -1831 4 16.9769 28.8628 1.74785 9.23997 -9.27082 -2.31394 -1832 4 17.6006 28.1534 2.93661 3.56557 1.38454 -8.44201 -1833 6 22.5099 30.1653 5.01109 -1.02808 20.8676 -0.473944 -1834 4 23.1753 30.1014 4.30975 -2.49536 -9.56192 4.09657 -1835 4 22.058 29.3206 5.04766 -1.45363 -6.71999 -4.50103 -1836 6 11.4023 8.80853 17.6459 -26.9993 9.53928 -4.75555 -1837 4 11.8645 8.1762 18.2108 15.3222 4.18532 1.52515 -1838 4 11.9865 9.48216 17.2519 4.47877 -12.4161 10.2871 -1839 6 32.2917 3.59674 26.8117 35.3382 32.7507 -4.14644 -1840 4 31.8458 3.34967 26.0065 -10.4154 -4.5889 -14.8452 -1841 4 32.8806 4.37505 26.5671 -21.1848 -26.3524 0.379863 -1842 6 26.835 37.1568 15.6529 -0.874066 14.8773 29.2405 -1843 4 26.7488 37.4766 16.567 0.376185 8.65421 -15.6923 -1844 4 26.6891 36.2303 15.7909 -0.851881 -23.4278 -14.9094 -1845 6 22.9473 3.40289 22.286 14.7574 -3.5158 -4.23343 -1846 4 23.2792 2.98888 21.4515 -4.53852 7.92848 16.4552 -1847 4 23.7307 3.68139 22.8048 -11.9145 -5.32443 -10.4265 -1848 6 14.6269 28.2214 5.19572 6.06687 6.51489 2.87291 -1849 4 14.1454 28.1555 4.36712 -3.39073 -3.27129 -8.45242 -1850 4 14.2747 28.9991 5.64824 0.61258 -1.12864 1.62503 -1851 6 20.2538 37.2031 16.5466 -28.2562 5.81675 18.2866 -1852 4 21.1004 37.4666 16.2032 21.0823 8.59207 -3.85991 -1853 4 20.0754 37.7549 17.3418 4.82626 -5.93036 -10.2325 -1854 6 17.9544 28.5616 23.889 16.4449 -8.57642 -4.83649 -1855 4 18.808 28.1928 23.5683 -20.3084 2.86715 8.85187 -1856 4 17.2559 27.9215 23.6535 6.51898 5.694 -2.26134 -1857 6 33.646 24.2349 25.2286 -4.54069 1.10679 -14.8717 -1858 4 33.6591 23.269 25.0602 3.54988 10.512 10.2941 -1859 4 34.0237 24.3938 26.1034 0.864522 -9.38336 -2.59148 -1860 6 9.98122 17.6138 2.21344 7.43797 -27.5786 -7.49496 -1861 4 10.832 17.5317 1.73219 -10.6429 3.93943 7.97636 -1862 4 9.86311 16.7639 2.69719 0.409905 15.8492 -4.6087 -1863 6 24.3357 36.801 8.92185 2.98992 -6.60779 12.1866 -1864 4 24.0742 37.6409 8.56425 -5.30422 15.3919 -5.44039 -1865 4 24.7315 37 9.77917 -2.43549 -6.6012 -3.30269 -1866 6 14.4004 4.29557 27.7519 47.583 -3.32523 5.14754 -1867 4 15.335 4.40276 27.3948 -30.4143 -4.44284 13.8265 -1868 4 13.81 4.42145 27.0177 -13.2435 3.17509 -11.8406 -1869 6 13.214 25.4576 35.3169 -22.1271 -24.6319 4.29258 -1870 4 13.1587 25.1592 36.2444 11.1778 9.47444 -6.90086 -1871 4 12.4637 24.9943 34.8985 11.1514 12.2923 -1.08233 -1872 6 43.7301 33.1781 24.4042 -1.93578 -20.5981 16.0744 -1873 4 44.3223 32.959 25.1725 -10.0543 8.3706 -19.7015 -1874 4 44.0713 33.9344 23.9169 6.22405 5.02536 3.22562 -1875 6 6.9686 30.4099 7.14637 29.0056 7.39031 21.9321 -1876 4 6.75777 29.9621 7.98042 -5.17066 0.417247 -5.37485 -1877 4 6.23168 30.2842 6.57126 -23.4728 -6.8193 -11.7975 -1878 6 44.4308 39.4237 21.7855 -4.33275 0.914597 7.54549 -1879 4 43.8654 38.932 21.1541 10.179 9.64354 2.62582 -1880 4 45.001 40.0603 21.3196 -6.51882 -12.4268 -7.79327 -1881 6 1.18424 16.4398 24.9903 -32.4903 25.5998 2.59769 -1882 4 0.976951 16.9992 24.2076 17.4753 -17.2203 8.72915 -1883 4 0.385168 16.6115 25.5394 23.4019 -14.126 -4.16352 -1884 6 8.17355 33.8284 10.6836 -2.7688 -6.92624 14.1509 -1885 4 8.34263 33.4451 9.83813 20.7133 -1.8248 -25.0865 -1886 4 7.32622 33.4212 10.8229 -22.0824 -0.650197 20.9959 -1887 6 45.3734 15.866 40.492 8.57481 -12.1553 -4.93844 -1888 4 44.519 15.6937 40.0698 -0.240559 4.546 7.41406 -1889 4 45.2892 16.6061 41.0987 -5.95018 0.957053 0.609678 -1890 6 38.79 4.28815 15.8976 0.37918 -2.10791 -10.8791 -1891 4 39.6838 3.98516 16.099 -1.14178 2.00828 6.51653 -1892 4 38.4576 4.71748 16.7012 5.69678 -4.45181 -3.36891 -1893 6 21.0946 9.20757 23.9781 -15.5567 7.8487 -28.256 -1894 4 20.9171 8.74785 23.1381 12.0597 -4.77706 12.6228 -1895 4 20.522 9.98378 23.8483 8.03519 -2.74416 16.612 -1896 6 6.47513 36.1489 20.0112 1.62078 -0.443995 1.26518 -1897 4 5.91587 35.3892 19.7749 1.1588 6.62155 -0.72477 -1898 4 7.29927 35.7814 20.3561 -3.99682 -1.77997 -1.59627 -1899 6 17.7466 23.4563 11.2529 28.5847 -29.2717 26.027 -1900 4 17.0283 23.9723 10.9251 -27.3158 17.875 -1.49359 -1901 4 17.6201 23.2782 12.2162 -8.22502 9.28058 -23.7318 -1902 6 2.23619 39.2644 23.5388 49.8561 -28.1857 -22.6679 -1903 4 2.97831 38.9599 24.1359 -27.9038 8.524 -11.8523 -1904 4 2.61824 39.0932 22.6246 -22.7997 11.7085 33.9524 -1905 6 21.7216 10.3211 3.08421 -18.2449 14.4951 30.0936 -1906 4 21.8041 10.0076 2.215 15.0715 -18.3252 -42.7176 -1907 4 20.7597 10.3501 3.18369 2.1836 1.89441 6.77029 -1908 6 13.3346 37.6456 26.8309 31.2085 -13.7023 -2.95714 -1909 4 12.8405 36.9633 27.2803 -9.16641 -7.21061 8.74396 -1910 4 14.167 37.1703 26.5501 -23.1686 18.0804 4.61389 -1911 6 45.6739 9.85296 8.82966 10.4005 6.57186 1.33947 -1912 4 45.3411 9.70411 7.93855 -5.0879 -2.60549 -0.62074 -1913 4 45.1871 9.30295 9.44221 -8.90854 -6.98805 -1.17873 -1914 6 39.813 32.3454 29.581 6.89703 -12.1014 5.95535 -1915 4 39.6485 31.4219 29.3549 -7.08038 -1.01192 -10.7476 -1916 4 40.3223 32.2375 30.3827 0.600223 8.34958 5.32896 -1917 6 39.1399 32.1558 8.97291 22.8595 -6.45003 -40.3239 -1918 4 39.6086 32.0592 8.09926 -10.5081 2.64219 35.3633 -1919 4 38.2198 32.2158 8.71089 -7.955 1.72328 8.07951 -1920 6 29.7568 11.3071 40.3305 36.1908 -28.2332 -10.1569 -1921 4 29.0987 10.6276 40.5022 -6.8613 -0.261357 1.73371 -1922 4 30.5966 10.7518 40.2867 -25.0211 23.0598 -1.19829 -1923 6 24.8367 19.8778 29.8512 -3.76004 22.8831 22.3698 -1924 4 24.8428 19.0032 30.2276 -1.20959 -17.1847 2.11456 -1925 4 24.5914 20.4528 30.618 6.24059 -13.3215 -18.0816 -1926 6 50.0702 29.4819 2.87168 7.70946 6.50978 -10.1722 -1927 4 50.8345 29.4231 3.46787 -5.92296 0.441099 -8.02421 -1928 4 50.4135 29.3271 1.96617 -11.3825 0.248157 19.2026 -1929 6 26.3309 13.2577 37.9673 -13.8105 -3.9786 -34.6653 -1930 4 27.2227 13.0528 37.6163 -4.21147 3.58808 27.148 -1931 4 26.2568 13.475 38.8976 18.37 3.27206 13.6317 -1932 6 24.3356 13.8068 16.1475 3.59325 -0.347239 -0.208698 -1933 4 24.7367 14.1162 16.9522 4.68271 -6.41054 14.6744 -1934 4 24.1923 14.631 15.6832 -6.43367 3.48529 -13.6665 -1935 6 21.9593 25.0956 8.01078 27.9223 3.76027 7.52529 -1936 4 22.6404 25.6041 7.51239 -14.7718 -5.75747 5.32796 -1937 4 22.4795 24.6555 8.71494 -11.0917 7.59151 -10.9937 -1938 6 50.1732 25.2931 29.034 -22.8769 -27.0861 -14.4889 -1939 4 50.9231 25.1249 28.4453 9.52927 7.92169 5.9345 -1940 4 50.3853 25.9631 29.6741 16.3661 14.9722 8.20298 -1941 6 23.1854 6.82331 7.6223 5.22953 23.7057 -4.54178 -1942 4 23.9785 7.3899 7.84298 -26.8007 -12.7469 -6.01791 -1943 4 22.4118 7.42329 7.468 18.2581 -13.076 4.30509 -1944 6 6.92213 5.8571 20.8332 2.72627 6.95854 -11.5419 -1945 4 7.54915 6.58218 20.6217 -11.8273 -13.0803 1.39721 -1946 4 6.56012 5.53917 19.9848 5.57208 -2.46181 7.62025 -1947 6 25.395 39.7583 23.949 6.36773 8.3837 -46.9746 -1948 4 25.6324 38.8356 24.0083 0.522678 -6.92882 12.1803 -1949 4 25.626 39.9451 22.9935 -8.38215 2.07882 31.2615 -1950 6 10.8464 30.695 2.12273 2.92699 -11.4721 29.0623 -1951 4 9.93667 30.8598 2.41274 2.41412 3.42254 -4.79395 -1952 4 11.0072 31.0743 1.26994 -5.60296 10.8359 -22.248 -1953 6 23.0784 40.5299 40.0517 -12.8303 7.3127 -19.6888 -1954 4 23.7801 40.7079 39.3995 -2.98216 -3.06267 5.67195 -1955 4 22.2752 40.9489 39.6621 13.0026 -6.04267 8.58422 -1956 6 29.2116 28.3822 37.564 -38.7174 33.0362 -17.1388 -1957 4 28.2182 28.3913 37.3962 39.4392 -4.09178 7.25715 -1958 4 29.4217 27.5495 37.9564 8.20519 -19.4736 9.10227 -1959 6 1.867 12.1738 18.0852 -6.50713 5.08339 -35.4355 -1960 4 2.57398 11.838 18.6163 6.10024 -5.16113 22.8519 -1961 4 1.13063 12.5086 18.5994 -2.48645 -2.83143 13.3981 -1962 6 35.8305 14.0949 8.56039 26.0881 18.3061 13.156 -1963 4 35.1714 13.4739 8.88749 -16.8661 -4.96187 -13.4504 -1964 4 35.7684 14.4109 7.636 -16.9096 -16.2229 2.78164 -1965 6 9.49198 39.8165 37.5846 25.5398 -19.6342 8.10058 -1966 4 10.4488 39.5668 37.3792 -35.3087 19.1509 -1.98674 -1967 4 9.11285 40.4907 37.0027 15.1686 -3.88151 -5.41116 -1968 6 3.54864 30.3444 19.2746 19.2588 -4.84534 25.5649 -1969 4 4.39288 30.8221 19.2218 -5.35887 2.33403 -8.35831 -1970 4 3.69938 29.8 20.0823 -8.98886 6.07327 -15.723 -1971 6 36.3172 32.3761 17.5568 -52.716 -14.5505 -10.7859 -1972 4 37.1181 32.7413 17.8285 45.3049 23.5946 19.1732 -1973 4 36.5447 31.7674 16.8589 0.0557097 -8.91784 -8.34906 -1974 6 22.0674 24.5243 41.4066 13.5104 10.4808 14.5301 -1975 4 21.9193 25.2614 0.114872 1.55544 -1.48024 -5.36737 -1976 4 21.3782 24.5469 40.7428 -11.5581 2.78113 -8.36201 -1977 6 45.7659 15.6016 11.6394 9.02046 4.78635 -7.96304 -1978 4 46.6299 16.0103 11.8091 -2.50167 -1.58301 0.968075 -1979 4 45.9087 14.6499 11.5698 3.7439 -8.72722 -0.994242 -1980 6 22.3679 20.3809 16.0361 -10.6504 -17.4294 -19.3744 -1981 4 21.763 20.3139 16.7773 -4.42579 5.53693 13.3566 -1982 4 23.0073 21.0579 16.2253 11.6801 17.1208 13.2616 -1983 6 25.8325 25.7487 18.9031 6.26908 13.5994 -10.9759 -1984 4 25.2398 26.4837 18.648 3.49723 -12.6326 6.8661 -1985 4 25.3435 25.2434 19.5576 -3.6765 -3.23145 -0.768961 -1986 6 35.3178 34.202 33.2905 -17.6504 -29.1706 1.13026 -1987 4 35.3983 35.1402 33.2641 1.24044 29.706 -1.15043 -1988 4 34.4344 34.0427 33.6774 7.05439 -0.467604 -1.03347 -1989 6 39.2901 17.1075 17.3833 -11.3112 -26.2042 -1.68945 -1990 4 39.9794 17.7123 17.5836 17.425 19.0869 4.79839 -1991 4 38.575 17.6263 16.9966 -1.50153 2.1098 -0.940241 -1992 6 0.398412 14.9432 21.7856 9.03058 1.70326 -1.90296 -1993 4 54.4474 14.9193 21.5731 -3.898 -0.019948 -1.7993 -1994 4 0.528431 14.174 22.3634 -0.170355 0.861544 -0.399335 -1995 6 15.987 23.2263 17.7743 4.36624 14.6934 -7.14303 -1996 4 15.4857 22.9799 16.9684 3.82047 1.22984 7.38673 -1997 4 16.1722 24.1939 17.7179 -4.44652 -15.4901 1.96988 -1998 6 5.24865 11.1141 17.5618 6.95422 37.8037 -9.42255 -1999 4 4.73778 10.3127 17.5906 4.69561 -15.2682 10.3552 -2000 4 6.07662 11.1201 18.0866 -14.6292 -19.4463 0.240297 -2001 6 9.34435 36.7122 13.2675 14.3848 -20.4853 -8.45434 -2002 4 9.62142 35.7704 13.1913 -3.31983 12.7393 -0.467066 -2003 4 9.65952 37.1602 12.4706 -4.49166 -2.86228 3.29419 -2004 6 25.4918 33.5767 0.585194 -13.2513 47.819 -13.0434 -2005 4 25.5067 34.5261 0.924259 2.87868 -31.0124 -5.96193 -2006 4 25.9276 33.0244 1.21144 10.5779 -12.847 23.4116 -2007 6 17.3034 24.3894 31.3332 -3.83374 11.0726 -5.16798 -2008 4 17.6693 25.1812 30.9068 -1.9735 -3.85303 -0.254684 -2009 4 16.6127 24.6926 31.9382 -2.66612 -1.73239 2.61398 -2010 6 50.552 32.7161 27.7939 3.69414 -2.86079 -12.6149 -2011 4 50.6897 33.0491 28.6758 -0.144502 8.45372 13.0825 -2012 4 49.6264 32.8868 27.6344 -12.0524 -1.73095 -4.05681 -2013 6 2.253 37.2274 16.11 8.45807 0.136394 4.49883 -2014 4 3.21927 37.2459 16.107 -3.10104 -5.97474 -11.5471 -2015 4 2.06307 37.5747 16.9848 -8.61924 1.9026 3.91491 -2016 6 25.7683 33.176 8.40354 -18.9203 -11.3347 4.07551 -2017 4 24.8717 33.1921 8.8134 13.9609 -2.48357 -8.81655 -2018 4 25.7602 32.4226 7.7918 -3.67744 3.53954 1.65329 -2019 6 24.768 7.83219 25.4219 17.632 21.1734 16.2998 -2020 4 25.4945 8.36147 25.0103 -20.1597 -14.0103 5.71998 -2021 4 24.2535 7.44908 24.728 -12.2137 -5.73332 -20.4071 -2022 6 44.006 27.3325 21.546 30.1554 -7.9652 -11.3918 -2023 4 43.2457 27.8583 21.7575 -19.7371 1.57643 -2.46296 -2024 4 43.7964 26.4976 21.0884 -11.5694 12.3441 5.98804 -2025 6 20.8391 32.0716 6.72617 12.9902 -8.35788 -26.5741 -2026 4 21.6065 31.456 6.61879 -16.2643 13.1482 10.0653 -2027 4 20.6646 32.3142 7.64123 9.40483 -3.67012 8.54308 -2028 6 0.615177 26.1024 3.99379 -2.52029 5.686 8.70358 -2029 4 0.872898 25.4419 3.3518 0.34785 -8.86692 -8.8337 -2030 4 1.24928 25.9906 4.70547 -1.00806 2.16518 1.82635 -2031 6 23.6932 0.22266 22.8575 19.6208 -9.09848 8.51526 -2032 4 23.2991 1.09802 22.9795 5.26519 -2.66393 -0.960482 -2033 4 24.6108 0.216177 23.2468 -26.6208 7.90328 -9.41734 -2034 6 35.6316 26.9489 6.47476 -11.9227 4.67096 -7.07616 -2035 4 36.2784 26.7656 7.18499 -0.847143 10.2035 -9.59556 -2036 4 35.6247 27.8854 6.12936 11.6979 -23.4314 22.5499 -2037 6 50.1669 7.09081 18.6924 -7.14542 -1.6973 -3.47771 -2038 4 50.8011 7.27946 17.9805 -1.08143 -0.293524 0.841141 -2039 4 49.7425 7.94753 18.8476 4.63932 0.367722 -3.05405 -2040 6 12.4741 14.8288 12.1922 -8.10271 -9.61402 10.4649 -2041 4 11.6958 14.4794 12.6802 13.1948 7.08912 -7.97814 -2042 4 12.1183 15.3251 11.4609 -4.91784 2.70917 -6.99785 -2043 6 52.4614 22.3688 36.3388 -11.0199 -17.3524 -23.0567 -2044 4 51.6251 21.9183 36.1306 -2.17212 11.6706 13.3338 -2045 4 52.9952 21.963 35.6316 8.38603 12.1418 11.4133 -2046 6 41.778 11.4842 39.1192 -2.94788 -8.5466 -71.3066 -2047 4 42.0712 11.6935 39.9642 18.9262 14.1801 48.2999 -2048 4 42.4688 11.7778 38.472 -13.5225 -5.5757 18.7019 -2049 6 13.7869 22.5139 39.1025 -32.0544 -7.10206 -10.9841 -2050 4 12.8164 22.2898 39.2995 40.1723 6.0649 -15.4789 -2051 4 14.0276 22.2847 38.1645 -11.932 2.241 24.8997 -2052 6 28.7471 19.519 21.8427 26.201 -31.4587 -3.42241 -2053 4 29.5077 18.8642 21.7553 -27.3151 19.4313 7.21597 -2054 4 28.709 19.939 20.977 -1.33904 3.86677 -3.41873 -2055 6 8.35104 21.6464 36.3873 -9.70021 11.1463 1.78198 -2056 4 8.59231 22.5715 36.3877 5.92817 6.74417 -5.91108 -2057 4 7.6521 21.6323 37.0621 1.10663 -7.27579 -5.05072 -2058 6 39.9466 23.9759 15.2079 21.5993 -7.98015 -41.1742 -2059 4 40.8727 23.6245 15.2724 -23.8836 11.1149 -0.884493 -2060 4 39.7538 23.9548 14.2182 -0.675121 3.14563 34.0025 -2061 6 8.14826 38.6974 22.5407 10.5164 -8.10765 28.5856 -2062 4 7.68497 39.3831 22.0542 -4.5186 11.15 0.90042 -2063 4 8.43687 39.0737 23.4204 -11.1896 -2.29822 -22.518 -2064 6 10.8609 20.1732 28.9608 12.8413 -0.923384 7.34695 -2065 4 10.0131 19.7426 29.0637 -5.9523 -4.47565 4.1188 -2066 4 10.8844 20.5008 28.0696 -0.703946 5.19258 -12.1525 -2067 6 36.9008 23.822 41.8156 -12.4363 21.7846 -10.0393 -2068 4 37.5711 23.2333 0.167128 40.9996 -19.7248 12.2972 -2069 4 36.1173 23.3131 41.9445 -23.6506 -5.40851 2.0223 -2070 6 23.7894 40.6868 33.3454 12.8596 -15.6087 -7.6142 -2071 4 23.0064 40.9655 33.8068 -12.9523 11.6172 4.83708 -2072 4 23.8763 39.7481 33.6232 3.5481 12.5289 -6.50269 -2073 6 4.67002 19.3025 35.4081 28.9654 -8.37802 15.8464 -2074 4 5.50304 19.0977 35.9037 -20.926 10.8248 -6.78781 -2075 4 4.54874 18.5079 34.879 -7.50763 -2.93955 -6.02594 -2076 6 9.44906 25.7726 10.897 4.32597 -4.58851 8.60165 -2077 4 9.18995 24.8319 10.8983 -5.5655 4.98255 -0.925486 -2078 4 8.69969 26.3126 10.6078 0.159443 -6.7376 0.514864 -2079 6 27.2776 22.4912 13.6121 -0.517147 -7.99313 -8.85992 -2080 4 27.155 21.7331 14.2088 0.0551372 2.14825 -2.63665 -2081 4 27.5226 22.1158 12.7439 -1.12325 6.52643 14.1544 -2082 6 41.0473 18.7721 23.2805 -1.65607 -7.19044 -7.91226 -2083 4 40.4257 18.2083 22.8124 7.09703 -3.21037 0.549063 -2084 4 40.4899 19.4448 23.6465 -2.2525 13.4867 10.2584 -2085 6 46.4847 28.3568 20.1596 21.4343 7.62243 20.4812 -2086 4 45.6558 28.0725 20.6313 23.6124 6.3397 2.68094 -2087 4 47.3103 28.4552 20.7557 -43.4876 -6.08109 -17.1535 -2088 6 14.856 15.3945 30.0569 12.1054 -1.48105 24.8406 -2089 4 14.6669 15.4041 29.1302 -8.67008 -4.83168 -20.7775 -2090 4 14.3859 14.629 30.4429 4.17574 5.50589 -6.96103 -2091 6 23.5299 24.7674 35.2089 8.01546 19.7663 24.3744 -2092 4 22.8065 25.3632 35.4756 2.8295 -9.26237 -7.23473 -2093 4 24.1647 24.8645 35.9517 -5.58112 -4.18239 -8.07128 -2094 6 19.8979 24.2128 28.4372 -8.55524 33.371 -10.5251 -2095 4 20.118 25.106 28.0235 -7.554 -30.7898 14.4583 -2096 4 18.9386 24.2465 28.5992 8.91169 -0.342387 -2.75065 -2097 6 45.9653 7.62821 20.2375 0.645938 -6.46631 40.9505 -2098 4 46.1455 7.81465 21.2011 -4.75538 -9.14986 -26.6761 -2099 4 46.2053 8.42523 19.7798 3.02803 13.7202 -10.1214 -2100 6 38.0274 12.476 8.2804 -12.7973 12.3245 -4.6187 -2101 4 37.3544 13.1993 8.5286 18.4233 -41.2645 -20.6098 -2102 4 37.689 11.8001 7.60922 -1.16355 31.2483 23.3325 -2103 6 46.9232 18.1908 8.45127 -20.6048 6.85227 14.7641 -2104 4 46.2435 17.4987 8.55233 4.56757 4.50302 -0.225601 -2105 4 47.4224 17.9381 7.68168 11.4282 -5.99968 -17.9171 -2106 6 10.854 13.9656 9.37577 10.6617 18.3473 -18.9154 -2107 4 10.3554 14.661 8.90618 -4.87744 -10.6328 11.7585 -2108 4 11.7492 14.0754 8.99486 -7.79483 -7.36366 10.4335 -2109 6 34.413 5.42618 14.0852 -12.6861 0.159125 26.6885 -2110 4 35.1199 5.9296 13.6715 10.4361 -4.78744 -13.6438 -2111 4 34.2786 4.53955 13.7091 11.464 2.02167 -7.62295 -2112 6 0.18261 0.234369 22.9555 2.77695 -16.1069 -0.480131 -2113 4 0.268342 41.6651 22.1144 -0.0234796 4.94264 7.55149 -2114 4 54.831 1.09037 22.7433 -8.12427 18.964 -5.90735 -2115 6 40.9343 30.5497 37.8912 -0.822728 -5.40818 -2.29365 -2116 4 40.0406 30.8803 38.1728 23.6728 -16.1598 5.2797 -2117 4 41.3254 29.8415 38.4693 -14.8835 20.0143 -6.13723 -2118 6 16.6534 17.3205 12.6874 14.7099 15.3782 -9.06546 -2119 4 16.1954 16.505 12.4572 -1.18797 -4.10455 -0.493236 -2120 4 17.006 17.6533 11.8352 -5.05849 -6.69802 12.8635 -2121 6 29.6898 5.4323 24.749 -0.0153423 -4.79708 -9.00604 -2122 4 30.3311 5.93507 24.2276 2.5605 1.293 3.45927 -2123 4 29.9547 5.54756 25.6733 0.859724 2.70473 -2.20341 -2124 6 49.8976 0.279 27.2063 11.3554 -10.6099 9.68168 -2125 4 49.8114 0.578981 26.2935 2.75523 0.634109 -3.06626 -2126 4 50.8097 41.8349 27.2847 -10.6363 5.42595 -5.44518 -2127 6 31.2372 31.739 15.2138 3.99594 22.7956 -4.27207 -2128 4 31.6256 30.8953 15.4507 4.79789 -4.71254 6.82751 -2129 4 31.9624 32.4004 15.1381 -14.4355 -14.737 3.33184 -2130 6 35.7805 24.1465 16.9504 11.9916 -3.59376 -8.04525 -2131 4 35.6914 24.9231 16.3572 2.28972 -11.6943 5.94213 -2132 4 36.6882 23.763 16.8157 -19.8391 7.30154 4.46135 -2133 6 24.2601 4.62781 36.7306 -2.73038 -12.1142 -21.0154 -2134 4 24.8177 5.17448 37.2794 5.25293 5.76293 7.44764 -2135 4 24.6802 4.67277 35.8537 -9.35577 -2.69704 9.81341 -2136 6 17.5719 12.8989 3.66466 27.7221 -13.8379 -12.2911 -2137 4 17.7111 13.5231 2.92461 -8.26776 -5.83385 13.2655 -2138 4 16.7968 13.1561 4.15408 -15.8703 8.33112 4.7305 -2139 6 4.16771 14.2922 18.2601 -1.91899 -29.1082 -10.1028 -2140 4 4.22837 13.3107 18.2109 4.90834 19.7408 -0.578384 -2141 4 3.27435 14.4381 18.5824 -9.9871 6.86755 4.44487 -2142 6 19.1699 36.8381 22.3902 -4.55286 10.0742 -5.97046 -2143 4 18.832 36.3461 23.1414 -4.92402 -9.67799 11.164 -2144 4 19.5712 36.1952 21.8056 6.33502 -12.5333 -3.55186 -2145 6 15.653 11.96 13.2084 19.351 18.6963 0.185202 -2146 4 15.6609 12.833 12.7547 -2.35489 -19.4305 9.56752 -2147 4 16.5767 11.8359 13.5469 -18.24 -1.16426 -6.81767 -2148 6 24.7461 21.9204 5.38797 -27.1503 3.38708 1.08719 -2149 4 25.0422 21.7466 6.29562 -9.42613 0.489783 0.293639 -2150 4 23.7615 21.7936 5.33342 31.5349 -1.60743 10.1723 -2151 6 52.731 18.5617 35.2291 -23.3227 -9.96089 -3.35821 -2152 4 52.3432 18.0885 34.4925 12.0283 -8.22578 -16.7439 -2153 4 51.9379 18.6142 35.7503 -4.18579 12.1235 24.3517 -2154 6 3.56339 27.2782 25.2861 -13.9068 -17.971 -11.9546 -2155 4 3.93933 27.1708 26.1554 6.48024 -2.07304 15.4908 -2156 4 3.97283 28.0403 24.8958 8.97188 17.1762 -5.24442 -2157 6 34.4703 32.9949 30.674 6.71734 26.132 41.1649 -2158 4 33.5303 32.9277 30.8218 -10.267 -13.4259 -20.1884 -2159 4 34.6757 33.5653 31.4552 13.6938 -14.1125 -21.2315 -2160 6 35.2703 23.7477 9.841 1.59588 4.98779 0.126485 -2161 4 34.557 23.9691 9.22977 0.987563 3.83206 0.754652 -2162 4 35.6213 22.923 9.5082 6.82753 -10.3388 -1.5208 -2163 6 42.4139 15.7114 8.97964 24.1102 0.334397 4.42901 -2164 4 41.6569 15.4185 8.4899 -23.1764 -3.9339 -8.15459 -2165 4 42.1019 15.9745 9.85446 -9.30455 -0.897043 1.06511 -2166 6 7.76859 28.8573 32.9442 -15.9037 16.0354 -10.4898 -2167 4 7.97908 28.1549 33.5519 6.36032 -10.9608 11.0673 -2168 4 8.54203 29.0732 32.4131 7.8922 -1.0693 -1.41065 -2169 6 17.6887 41.2397 36.4833 -13.2152 -10.2381 33.1554 -2170 4 16.9194 41.8027 36.6113 -2.7651 1.17246 3.809 -2171 4 17.9462 41.408 35.602 16.1966 5.46369 -29.7656 -2172 6 28.4973 24.2486 15.5471 -12.6583 -10.112 -30.4241 -2173 4 29.1017 24.9078 15.1992 6.65529 6.29726 4.69488 -2174 4 28.2904 23.7156 14.7389 1.39534 3.17619 21.4563 -2175 6 20.9519 16.2974 1.15248 44.1264 9.982 -6.69009 -2176 4 20.9895 15.4004 1.43432 -0.0798072 -22.9414 11.198 -2177 4 20.0538 16.5254 1.09156 -44.6028 7.62895 -2.50253 -2178 6 31.1717 40.7384 5.29995 -1.14335 -24.9234 -14.6262 -2179 4 30.3101 40.4535 4.98914 0.542473 -7.39845 -0.335603 -2180 4 31.0069 41.6267 5.54556 -2.10438 36.1837 12.2935 -2181 6 29.9172 24.7601 36.4536 2.52587 12.7881 -5.39704 -2182 4 30.4095 25.4459 35.9567 -7.35112 -4.48214 8.13095 -2183 4 30.0744 23.9625 35.9621 2.47343 -16.947 -5.4104 -2184 6 8.66853 31.0461 3.90506 3.77884 -22.5587 -9.29968 -2185 4 7.73756 30.8263 3.92016 -7.28297 1.54323 -1.95967 -2186 4 8.75192 31.9258 4.24445 1.80419 26.3875 10.0131 -2187 6 5.53845 32.6958 11.4143 8.71933 -16.8124 -2.49586 -2188 4 4.77303 33.2403 11.6664 3.11219 -11.1916 -2.75881 -2189 4 5.22904 31.759 11.32 0.456358 25.4252 4.80969 -2190 6 45.6505 35.4572 20.4414 3.44959 -7.44503 -2.03407 -2191 4 45.0984 35.4295 19.6379 6.4013 -0.712815 7.57821 -2192 4 46.1919 34.6303 20.4513 -12.6908 13.7486 -3.45541 -2193 6 19.5117 2.78375 9.7759 -32.3978 -9.59039 -17.0694 -2194 4 19.2358 3.70482 9.71872 -0.134373 3.8207 4.89971 -2195 4 18.7417 2.29322 9.36028 25.7327 11.9734 13.3495 -2196 6 54.9587 9.07031 10.9149 6.82732 -5.63024 12.2566 -2197 4 54.8294 8.9199 11.8667 -4.4018 -2.06217 -5.32285 -2198 4 0.663346 9.73371 10.8556 1.49355 -0.124783 -2.42855 -2199 6 21.0387 26.5729 14.7801 20.1883 -1.49652 -44.4677 -2200 4 21.3075 26.2685 13.8316 -13.9911 15.8829 47.28 -2201 4 20.1009 26.3915 14.9175 1.72514 -4.1332 -5.78598 -2202 6 14.1556 30.5195 27.5512 33.9559 3.86758 5.7066 -2203 4 14.6157 30.1887 28.3748 -9.20473 8.28645 -28.3289 -2204 4 14.8625 30.9321 26.9648 -24.7422 -11.1229 20.6028 -2205 6 29.8153 17.3336 31.0863 -17.242 12.2647 2.89366 -2206 4 30.6608 17.508 30.6961 22.1461 -2.37775 -6.86255 -2207 4 29.3509 18.1813 30.9961 -0.156979 -6.11616 8.89085 -2208 6 50.8803 17.2897 27.8178 -36.3925 19.5692 4.68662 -2209 4 49.966 17.6961 27.8739 30.6942 -17.822 -8.40051 -2210 4 51.3989 17.8346 28.4178 4.99425 -5.86793 -0.268148 -2211 6 46.2649 37.0836 13.9834 -5.2064 -3.89214 -29.9265 -2212 4 46.1297 37.5324 14.8008 -1.4234 12.1478 29.9589 -2213 4 45.6025 37.4999 13.3985 5.55615 -7.46483 0.310394 -2214 6 38.1938 37.2652 33.1426 -7.30823 -21.5307 12.8964 -2215 4 38.5245 37.3061 34.0621 0.43181 3.22683 -10.2889 -2216 4 38.5338 38.0078 32.6437 8.99657 15.0472 -1.17828 -2217 6 41.835 13.3432 31.1173 -10.6585 13.9874 21.8211 -2218 4 41.5818 13.8647 31.919 4.55225 -14.0949 -20.2689 -2219 4 42.3932 12.6177 31.4161 6.34511 -7.13184 -1.29627 -2220 6 46.8964 12.6581 17.833 -7.85032 10.4907 -16.4819 -2221 4 46.6484 13.6178 17.7542 4.08188 -24.8978 -7.40371 -2222 4 46.6377 12.1709 16.9987 5.46876 16.7046 19.0746 -2223 6 32.0579 10.0934 10.6503 -8.64381 28.9058 -4.43215 -2224 4 31.7849 9.65569 11.4853 0.173068 15.3159 -11.0765 -2225 4 31.7767 11.0763 10.6467 12.4785 -48.8318 10.7993 -2226 6 34.0094 11.373 6.75969 12.8388 24.8548 11.4886 -2227 4 33.4875 10.5861 6.69386 -15.1181 -21.0438 1.83339 -2228 4 33.7853 11.7772 7.62543 1.85262 -6.17932 -11.7084 -2229 6 45.3294 30.8612 19.494 8.3992 -12.4908 2.66791 -2230 4 45.3133 30.6326 20.4263 -2.2594 2.91399 10.7741 -2231 4 45.8271 30.1094 19.1443 -2.81922 5.63857 -5.34771 -2232 6 20.3557 0.57205 7.14927 -0.865045 4.87397 8.36509 -2233 4 20.1887 0.590785 8.10086 -2.30268 5.48708 -2.96522 -2234 4 20.2885 41.5556 6.94299 -1.24307 -13.5357 -7.1472 -2235 6 15.9783 39.4524 4.13892 -0.0151964 -9.48015 -5.29824 -2236 4 15.6158 39.9898 3.41173 1.6648 1.85694 12.5404 -2237 4 15.64 39.7774 4.99485 -4.20756 5.15612 -10.0141 -2238 6 52.4256 16.4667 25.1127 -17.0507 13.8269 -2.02364 -2239 4 51.8848 16.9346 25.7614 0.982734 -7.60925 5.82434 -2240 4 52.3383 17.0704 24.353 8.48557 -12.5426 -0.219872 -2241 6 38.5361 13.0039 3.23845 15.1533 54.069 38.768 -2242 4 38.651 13.64 4.04305 -2.16968 -28.4467 -44.0011 -2243 4 38.0019 12.309 3.58724 -16.6469 -22.8542 0.297491 -2244 6 35.13 29.6899 31.1766 -32.8294 1.63854 50.8714 -2245 4 35.4825 30.1651 30.4465 16.0479 15.276 -26.3528 -2246 4 34.6741 30.3613 31.7643 12.1102 -21.125 -19.7306 -2247 6 9.51973 33.7498 4.86217 -21.8826 5.77433 4.68556 -2248 4 9.27059 34.3826 5.57285 8.50621 -13.5655 -12.6408 -2249 4 10.3866 33.3952 5.041 8.90701 -1.44023 3.12186 -2250 6 21.534 22.0642 20.5279 -11.3341 -5.53839 17.2976 -2251 4 20.8989 22.7675 20.339 3.51908 1.76985 -0.685914 -2252 4 21.3133 21.7346 21.437 6.74336 6.48682 -22.5749 -2253 6 37.579 11.1901 41.2936 -40.5688 -13.8213 19.6839 -2254 4 37.9154 11.8125 40.6731 20.8822 18.4609 -22.3708 -2255 4 38.2848 10.6639 41.6667 19.2795 -3.39896 1.21846 -2256 6 33.8862 1.42431 38.7362 -9.76991 -12.243 -0.11253 -2257 4 33.6023 0.553369 38.4181 2.20193 5.31751 1.25532 -2258 4 33.9041 1.3558 39.7008 -0.574955 5.51976 -3.65617 -2259 6 4.57166 26.6812 27.9899 28.8485 -45.5436 -4.48952 -2260 4 5.15229 25.8908 28.1565 -23.3183 20.9594 -13.553 -2261 4 4.90489 27.293 28.6243 -0.866291 24.6335 11.5543 -2262 6 10.2514 0.902381 11.6154 -4.58149 -17.6537 26.8062 -2263 4 10.6592 1.12475 12.4668 -4.26503 -7.612 -8.38981 -2264 4 10.5004 1.60734 11.0484 5.83944 23.9466 -26.0443 -2265 6 17.6545 19.8255 2.35686 18.7122 -0.118329 6.29025 -2266 4 17.9031 20.43 1.64019 0.754008 -4.0492 2.7955 -2267 4 18.4832 19.3436 2.60738 -15.0404 10.1651 -4.64219 -2268 6 32.418 25.6758 16.4635 3.6076 24.4214 11.9097 -2269 4 33.0171 26.0095 17.1449 -9.06157 4.09224 -4.99535 -2270 4 32.7904 24.838 16.2462 -1.14602 -28.0291 -11.1265 -2271 6 33.2468 10.6359 0.32388 9.93322 -26.76 -6.12289 -2272 4 32.8861 10.0042 41.5485 10.341 19.2926 16.9559 -2273 4 34.0854 10.2367 0.697563 -23.7256 11.8288 -10.1734 -2274 6 4.94758 4.52061 10.1416 10.7499 4.98188 17.9077 -2275 4 4.04768 4.863 10.1726 -0.273394 -4.88493 2.42241 -2276 4 5.29522 4.53942 11.0694 -10.4701 1.63881 -23.2648 -2277 6 27.0943 16.9779 9.5563 -20.4641 3.47693 -11.2288 -2278 4 27.2045 17.5151 10.3493 -1.38601 2.5137 2.70549 -2279 4 26.2214 17.2494 9.17658 21.4447 -4.2653 12.7286 -2280 6 9.99194 10.5198 19.3763 9.42123 -1.05348 44.8422 -2281 4 10.4342 9.89794 18.8118 9.85784 -12.5922 -17.5865 -2282 4 10.1605 10.162 20.3013 -9.67835 15.4527 -31.558 -2283 6 19.5738 8.53792 27.8563 25.8928 -1.13542 15.4327 -2284 4 20.113 8.77024 28.6584 -12.6361 -5.62488 -23.922 -2285 4 20.1113 7.87775 27.3567 -13.5748 14.3815 9.08869 -2286 6 47.0629 38.9588 23.1271 -13.9792 1.44752 0.432651 -2287 4 47.6691 38.8737 22.3925 4.22694 -4.47738 -4.61135 -2288 4 46.1776 38.8683 22.7344 3.33277 3.24373 3.79368 -2289 6 19.6833 25.3678 11.2608 -44.4501 -0.725843 0.650565 -2290 4 19.0139 24.6272 11.3182 24.6346 19.551 -2.60477 -2291 4 19.1544 26.1629 11.5326 10.4738 -19.1562 -5.87093 -2292 6 27.3884 13.4531 15.7313 17.4935 -10.3398 7.87305 -2293 4 26.7289 13.8255 16.2909 -22.225 11.7393 10.4827 -2294 4 28.1076 13.2654 16.3619 5.43008 -3.78237 -14.8549 -2295 6 18.6476 14.1287 1.42435 5.12245 -4.46092 -43.403 -2296 4 18.3969 15.043 1.25229 -6.07889 7.26273 6.76186 -2297 4 19.169 13.9274 0.593091 -12.995 -1.5013 29.2583 -2298 6 42.2956 22.0175 32.4812 -31.5033 5.69606 -11.9689 -2299 4 42.0953 21.6028 33.3343 -5.26012 -0.0861087 1.91793 -2300 4 41.4492 22.4721 32.2087 27.3869 -15.7461 8.96812 -2301 6 10.0338 9.4525 2.5044 21.0744 -25.1182 9.26795 -2302 4 9.23419 9.82009 2.8603 -22.4046 15.9317 4.21557 -2303 4 10.2146 8.68383 3.09556 -0.513225 11.8796 -14.6695 -2304 6 6.81454 1.43994 21.9965 -17.8896 2.42247 -7.4431 -2305 4 5.91626 1.63042 21.618 24.8197 -16.2049 7.25345 -2306 4 7.09146 0.513113 21.8391 -15.5061 11.1514 -4.64506 -2307 6 11.279 27.0428 18.9739 -2.94846 37.5248 -0.887691 -2308 4 11.8405 27.0241 19.773 -2.49358 0.901506 -7.48985 -2309 4 11.2189 28.0198 18.7087 3.35633 -32.7966 13.2637 -2310 6 41.4624 20.5117 27.2131 -8.71247 23.609 -19.3396 -2311 4 41.6397 21.203 27.8749 -2.09795 -12.5822 -0.139714 -2312 4 41.4581 19.6661 27.6488 3.25287 -9.08293 14.2442 -2313 6 15.4472 24.107 33.4286 7.47915 5.78269 -2.8589 -2314 4 14.6947 24.3175 34.0087 6.10264 -6.26217 -2.67023 -2315 4 15.704 23.1687 33.5026 -8.54671 4.87938 10.939 -2316 6 36.1332 16.3778 10.0175 -2.81296 8.13669 8.31829 -2317 4 36.0433 15.4982 9.63146 0.0153009 -3.05325 1.23302 -2318 4 36.1908 16.2895 10.9807 1.05799 -3.5475 -8.17119 -2319 6 51.7056 16.2618 2.12066 8.195 -18.8618 -27.7488 -2320 4 51.3212 16.7491 2.82948 -13.5116 6.32013 30.1636 -2321 4 51.8333 15.3227 2.36395 -2.62212 15.8907 6.5854 -2322 6 23.4154 8.54771 39.774 19.4785 -4.07885 -14.0827 -2323 4 23.6619 8.92799 38.8876 -4.40964 -10.2511 30.1282 -2324 4 24.1933 8.06554 40.1323 -10.8686 15.1901 -10.9325 -2325 6 36.7652 34.4407 21.0996 -10.7203 -4.0633 -8.35763 -2326 4 37.1575 34.5988 20.2292 -2.24352 0.118594 1.89686 -2327 4 35.7922 34.4168 20.9564 13.0606 -0.027129 3.88767 -2328 6 14.1394 8.88964 27.2822 8.4001 33.0473 -16.3093 -2329 4 13.5583 8.17177 27.4325 -25.1847 -27.8879 6.89622 -2330 4 14.9981 8.62308 27.6007 12.278 -0.771553 4.38 -2331 6 20.6523 37.4857 25.1916 -4.76336 -9.80096 2.89409 -2332 4 20.8435 36.6327 24.7231 -2.60537 24.8018 1.29013 -2333 4 20.5883 38.2205 24.557 2.95927 -14.0914 0.587832 -2334 6 28.8259 24.466 30.0361 -12.0182 1.20484 18.6414 -2335 4 28.1863 24.5363 29.306 15.5663 0.0495978 -2.57679 -2336 4 29.6571 24.0617 29.7579 -0.701354 -5.27936 -13.535 -2337 6 8.3767 11.9994 23.6977 15.286 -11.9681 20.7139 -2338 4 9.3753 12.0245 23.8359 -31.6027 -4.22616 -3.50543 -2339 4 7.96209 11.4264 24.4013 16.8905 14.3689 -13.5243 -2340 6 16.0974 26.6628 22.9497 0.767107 4.93659 2.67852 -2341 4 16.422 25.9025 22.452 -4.69466 0.466105 1.02544 -2342 4 15.3072 26.4353 23.4595 5.90508 -1.9072 -2.1838 -2343 6 22.3492 41.3933 9.48833 17.1541 -15.2597 3.14364 -2344 4 22.6076 0.330473 9.13574 5.89797 15.5422 -4.87712 -2345 4 21.4389 41.4869 9.73785 -21.2641 2.73615 1.78898 -2346 6 49.3865 19.1849 32.379 28.5034 -27.5288 -8.8444 -2347 4 49.9591 18.5119 32.8294 -20.0237 22.3317 -7.01358 -2348 4 48.8882 19.6696 33.032 -5.7885 3.32597 15.4548 -2349 6 29.6797 28.4194 31.2347 -18.17 -6.54897 12.3532 -2350 4 30.6054 28.3362 30.9452 0.112823 -13.8933 8.50124 -2351 4 29.3632 27.6339 31.7874 27.6893 19.0339 -22.4607 -2352 6 5.1089 39.1304 23.5821 16.3589 -26.7425 38.52 -2353 4 5.38369 38.72 24.4786 -14.1195 25.2427 -41.8592 -2354 4 5.12138 40.0884 23.679 1.29424 5.88982 9.05127 -2355 6 42.9406 13.5828 41.5963 2.4548 -20.3274 5.45752 -2356 4 42.752 14.3543 41.1051 4.71299 30.6973 -25.311 -2357 4 42.1302 13.4831 0.159852 -12.9765 -12.2431 17.3873 -2358 6 21.226 12.4267 7.36435 31.2446 -3.521 -2.03074 -2359 4 20.2961 12.4647 7.18572 -19.4619 -2.59914 -12.879 -2360 4 21.5838 11.6146 6.96487 -5.92297 6.31526 1.33966 -2361 6 43.1402 26.8798 37.6925 36.8226 -18.0871 25.2922 -2362 4 42.3701 26.4861 37.2457 1.92095 -10.9538 3.42147 -2363 4 43.8051 26.2366 38.1772 -44.9135 25.1765 -29.4158 -2364 6 19.5374 10.6589 41.6895 -5.57828 -38.0023 -10.1688 -2365 4 19.1336 10.6448 0.637369 -6.5477 2.89313 17.0607 -2366 4 19.8005 11.5407 41.5226 10.6711 39.664 -4.3781 -2367 6 53.6211 10.0725 3.2523 6.57913 5.47914 -9.18923 -2368 4 54.2317 10.83 3.34927 -4.54537 -9.93589 0.0420736 -2369 4 54.0384 9.44833 2.62164 -2.29754 8.8252 9.03809 -2370 6 17.5636 20.1992 28.4305 -16.5699 17.1528 15.5915 -2371 4 18.0548 19.7019 27.7957 9.40873 -10.9714 -15.8242 -2372 4 18.1497 20.2955 29.1876 1.50874 1.07066 2.83373 -2373 6 36.8673 7.33814 1.69171 -42.7001 9.70605 -8.47937 -2374 4 37.6788 7.60022 2.09727 18.2611 10.2246 9.26811 -2375 4 36.4242 8.16776 1.39628 11.5951 -12.345 5.16871 -2376 6 29.225 41.4226 1.83075 -19.1389 21.107 -1.05665 -2377 4 28.4254 0.0289368 2.09685 16.3458 -11.1471 3.47601 -2378 4 29.1672 41.4088 0.871311 7.531 -2.47214 -5.14574 -2379 6 13.5148 3.09025 8.11784 -10.8355 13.5741 -3.86075 -2380 4 12.8447 3.80664 8.08285 8.27234 -10.6709 -2.48032 -2381 4 13.8247 3.09872 9.02804 1.30446 -5.60755 1.07776 -2382 6 15.035 29.5824 18.5052 -13.3664 3.09019 -9.07378 -2383 4 14.628 28.8743 17.9722 6.78876 3.62049 6.93265 -2384 4 14.2975 30.1967 18.6986 12.8362 -2.82157 -1.1162 -2385 6 10.5118 24.7077 24.3903 18.3301 23.9761 -31.3173 -2386 4 10.707 24.7057 23.4146 -4.2845 7.89501 28.372 -2387 4 10.0612 23.8909 24.4849 -17.9274 -27.8 13.6507 -2388 6 2.3293 13.8562 25.1542 8.14415 -2.44132 2.05706 -2389 4 1.63302 13.4321 24.6436 -3.32338 -7.08116 -5.4939 -2390 4 2.0923 14.7815 25.112 -7.52471 9.11743 -0.122921 -2391 6 31.8571 32.759 29.7983 3.65167 10.3578 -8.56752 -2392 4 30.9277 32.9381 29.9784 -0.622435 -3.80813 0.732423 -2393 4 31.8884 31.8723 29.4276 -3.71181 -5.10697 -2.58235 -2394 6 37.531 40.8209 33.967 -23.153 -16.1875 5.3836 -2395 4 37.3251 40.1347 34.6985 0.870468 26.6491 -35.3147 -2396 4 36.773 40.8784 33.3102 18.3716 -9.25033 25.8989 -2397 6 24.0485 38.1313 34.3431 -11.5105 1.837 -35.773 -2398 4 24.1907 38.198 35.2802 9.24451 -7.73664 19.5979 -2399 4 24.4675 37.3552 33.934 1.62169 3.10325 14.1331 -2400 6 37.1852 22.5711 7.36841 5.54302 -17.8805 15.7599 -2401 4 37.6193 21.7136 7.5635 -9.24307 15.2983 -3.07678 -2402 4 37.2973 22.7156 6.43503 3.10694 -1.55352 -15.3513 -2403 6 4.30637 23.241 35.6005 -21.8515 -3.12039 0.833232 -2404 4 4.28153 22.3978 35.1252 -1.17938 4.50836 1.52069 -2405 4 3.36633 23.5034 35.7569 13.5984 -2.36814 -1.35472 -2406 6 15.7372 14.8984 2.68389 5.83394 8.18523 30.6602 -2407 4 16.0581 15.8209 2.80401 -5.66096 -17.7803 -6.78984 -2408 4 15.4195 14.7671 1.79524 0.865375 8.28049 -11.4308 -2409 6 48.1667 23.1873 2.04358 2.14857 -5.2771 -14.5053 -2410 4 48.6748 23.4267 2.82287 11.4848 0.866046 3.26637 -2411 4 48.7964 22.9219 1.32588 -13.3162 5.875 14.6145 -2412 6 24.1221 19.9752 21.5371 -32.3717 23.6383 6.86593 -2413 4 24.143 19.3917 22.3107 11.6246 -2.80692 -10.3828 -2414 4 24.7866 19.7762 20.8968 22.5091 -14.1667 -7.68302 -2415 6 10.5822 29.3968 5.14403 -6.21678 -11.6361 15.7318 -2416 4 9.83188 29.7897 4.67624 10.1791 9.93667 -6.35089 -2417 4 11.4324 29.7717 4.90568 -2.60747 8.99296 -10.7541 -2418 6 5.96985 27.6957 31.2251 14.0826 -21.4471 -14.909 -2419 4 6.62108 27.1001 30.7651 -15.2176 13.0885 7.83628 -2420 4 6.49554 28.1541 31.8886 3.5811 4.10899 4.91189 -2421 6 18.524 25.7945 15.3346 -6.80319 -1.26411 -41.3947 -2422 4 18.3129 25.8537 16.2191 -1.03447 -6.47723 71.4836 -2423 4 17.8509 26.3975 15.0287 -5.96066 9.61194 -22.438 -2424 6 52.0911 37.2147 11.1191 10.7944 -12.7592 -3.2574 -2425 4 52.6735 36.5031 10.7991 -6.06835 6.24709 5.19982 -2426 4 52.6754 37.9802 11.2539 -6.64808 -1.57102 -0.449092 -2427 6 46.8545 14.6154 7.32174 -10.4102 9.08531 6.17155 -2428 4 46.1761 15.2305 7.76384 29.9054 -34.6086 -7.32766 -2429 4 47.196 13.9114 7.91569 -13.0839 18.0399 0.731203 -2430 6 22.2426 0.701706 41.6733 41.1626 12.534 -29.9538 -2431 4 22.236 1.66756 41.6378 -9.79705 -6.68715 4.90956 -2432 4 23.0808 0.492341 41.1545 -29.2322 -0.545859 23.5967 -2433 6 4.06645 14.7285 9.26505 -5.79968 22.7562 -12.5209 -2434 4 3.53709 15.5501 9.07402 9.13976 -21.8289 3.48331 -2435 4 4.94549 14.9564 8.94351 2.1847 -1.50717 0.750146 -2436 6 37.293 12.6643 37.0348 -15.3153 -6.18171 16.0178 -2437 4 37.7524 12.8164 37.9019 -17.8573 -2.14895 -9.99561 -2438 4 36.3666 12.3049 37.1727 33.7628 8.85249 1.83374 -2439 6 26.6624 29.0693 40.5955 -26.637 27.4899 13.7151 -2440 4 27.0962 28.2693 40.8235 19.1059 -29.7051 -2.9078 -2441 4 26.7436 29.2635 39.6647 9.93266 -1.33043 -11.4317 -2442 6 7.23743 13.8563 3.32048 -33.1041 -30.3754 -14.41 -2443 4 7.96064 14.4301 3.56742 25.5688 -7.52041 0.820923 -2444 4 7.42976 12.8854 3.09984 6.81051 43.2082 15.4509 -2445 6 8.94797 34.8532 28.8254 23.4184 -23.2786 -12.4265 -2446 4 9.89546 35.0323 28.6727 -12.7097 -5.00209 3.03018 -2447 4 8.59604 35.6886 29.0779 -14.3686 23.8739 12.2374 -2448 6 37.2014 40.0808 40.1141 12.7521 0.43192 13.6168 -2449 4 36.2619 40.0837 39.9632 -10.4254 2.72875 -6.67898 -2450 4 37.248 39.4512 40.8496 7.71934 0.19736 -2.65382 -2451 6 30.3728 6.17428 27.2502 2.34222 12.9127 24.6773 -2452 4 30.0491 5.75377 28.1093 17.5599 21.8776 -23.7977 -2453 4 31.0277 6.90628 27.4549 -18.5498 -22.5685 3.02853 -2454 6 10.4851 22.8816 18.2947 -6.39025 -14.7202 -25.3901 -2455 4 11.3539 23.0451 18.66 8.78619 -1.44678 0.615593 -2456 4 10.601 22.3432 17.4702 -0.435219 15.7289 22.4338 -2457 6 35.9047 14.2516 40.1476 -11.9566 8.08227 -8.12446 -2458 4 35.3828 14.5983 39.4171 17.9635 11.5828 -3.36223 -2459 4 35.2535 13.6726 40.504 -8.36759 -16.975 21.7169 -2460 6 6.70775 1.0715 17.7189 7.50642 -21.2746 -7.36561 -2461 4 6.22784 1.34485 18.5084 1.44497 -10.5234 3.95628 -2462 4 6.91772 0.0894674 17.7256 -13.4419 30.1572 13.7277 -2463 6 41.3365 34.0623 33.1636 23.1157 -5.84267 13.8333 -2464 4 40.4227 34.234 32.9444 -15.3258 11.3352 -14.6542 -2465 4 41.9184 34.5849 32.5841 -12.4833 3.91505 -3.84565 -2466 6 37.2858 0.99342 41.2878 7.36827 13.3221 -16.8172 -2467 4 37.4859 0.112276 40.9658 -1.88555 -12.2628 0.361589 -2468 4 37.4834 1.0172 0.312287 5.29267 -3.40266 15.6364 -2469 6 25.2541 30.9749 6.2071 -22.7336 2.5299 17.3506 -2470 4 26.0217 31.2424 5.69829 1.89843 -3.96463 -15.2281 -2471 4 24.4182 30.8551 5.69564 23.045 5.74277 3.20871 -2472 6 14.1871 24.4929 28.313 -6.35756 40.4048 -1.58139 -2473 4 14.3311 23.6816 28.7714 -3.10946 -31.1704 -0.0360927 -2474 4 13.792 24.4319 27.4273 2.40698 -14.1025 6.50138 -2475 6 34.2078 26.2332 36.0169 -41.3887 31.6455 20.302 -2476 4 35.1375 26.2713 36.1926 18.3831 1.21525 6.50399 -2477 4 33.7458 26.9646 36.5669 26.0782 -29.6148 -21.0343 -2478 6 32.3696 8.32545 27.9988 -31.7689 14.924 14.5852 -2479 4 32.5206 9.30939 28.0669 10.5891 -30.1429 -9.37737 -2480 4 33.1235 7.86931 27.6333 20.3768 10.5357 -6.59273 -2481 6 11.7881 0.276326 26.9686 -1.26514 -24.1343 -2.09554 -2482 4 11.7898 41.2288 26.6922 -1.19404 21.3361 9.01519 -2483 4 11.5977 0.31005 27.9205 2.09711 -1.6438 -10.9729 -2484 6 1.68282 0.256654 10.3371 7.78574 -7.1909 -12.7427 -2485 4 1.59984 41.2742 10.69 -0.913761 -2.35777 -0.20094 -2486 4 1.41183 0.821253 11.0453 -5.61238 10.3042 16.839 -2487 6 6.75659 13.8554 8.24275 2.15336 8.75665 -12.4729 -2488 4 6.4538 13.9004 7.29654 11.603 6.79512 25.9161 -2489 4 7.29723 14.6482 8.44053 -3.39366 -6.31817 -8.96948 -2490 6 22.229 20.5516 6.16712 -19.4021 -6.23502 11.2792 -2491 4 21.7175 21.3783 6.29668 6.22315 -10.0472 -0.391558 -2492 4 21.7004 19.8262 6.58709 9.33903 15.1246 -7.94106 -2493 6 17.3809 20.4508 10.8712 -6.33142 3.08518 -4.04876 -2494 4 16.5461 20.08 10.4568 21.8919 23.129 5.85777 -2495 4 17.5363 21.4129 10.6625 -13.97 -26.3983 1.7074 -2496 6 17.7006 4.52466 19.5892 5.66371 -4.97651 -9.86024 -2497 4 16.9376 4.52739 20.1892 -4.06273 -5.34645 -7.80596 -2498 4 17.5412 3.84457 18.8839 -0.885651 16.9891 23.3258 -2499 6 0.475545 18.1168 40.0844 5.30586 -7.45209 -16.0452 -2500 4 0.255658 18.7395 40.7612 -0.602959 14.3131 10.4938 -2501 4 1.33302 18.3868 39.7002 -7.70736 -6.31105 3.74686 -2502 6 22.9439 24.8338 27.8349 -3.23408 23.09 -51.7359 -2503 4 22.7283 25.5292 27.1178 5.97449 -27.0764 31.3639 -2504 4 22.8278 25.2464 28.677 -4.11703 14.8593 21.0934 -2505 6 42.7959 39.1553 26.7627 -13.6288 14.9904 24.3142 -2506 4 42.9559 38.4383 26.1586 10.7263 -7.78522 -15.113 -2507 4 43.351 39.9224 26.5692 3.77188 -7.24305 -5.18193 -2508 6 26.2354 3.05796 21.7982 1.74018 25.1467 -10.7915 -2509 4 25.6923 3.78105 22.1642 10.9011 -13.8467 -3.1836 -2510 4 26.7888 3.50003 21.1142 -10.0122 -11.5362 10.4851 -2511 6 54.6007 9.88011 29.5829 2.61324 -0.835643 16.9334 -2512 4 53.983 9.1383 29.6239 1.49377 0.577448 -2.59463 -2513 4 54.746 10.0983 30.5296 -2.21833 -1.79811 -18.9561 -2514 6 24.7578 33.7363 20.5387 -17.5006 5.04967 -0.0763559 -2515 4 24.6934 34.6555 20.8512 7.60819 -4.12262 3.6003 -2516 4 23.9235 33.6132 20.0554 5.3121 -3.42637 -1.44671 -2517 6 41.6963 16.3109 0.897802 2.88421 10.066 -28.0255 -2518 4 41.3077 16.0362 1.70176 -16.3219 -5.78099 30.2108 -2519 4 42.6299 16.1901 1.06805 12.6035 -3.11322 -2.97519 -2520 6 23.404 27.9303 27.4821 -1.06023 20.2241 -21.3645 -2521 4 22.8141 28.2554 28.1835 2.551 -1.87769 -8.73241 -2522 4 23.2629 28.4828 26.6516 2.17993 -16.4871 31.3925 -2523 6 32.7813 37.2936 18.7328 38.5641 -14.7697 6.75932 -2524 4 33.752 37.1016 18.9061 -34.9795 -0.437252 0.892363 -2525 4 32.8311 38.1729 18.3762 -6.70298 14.6722 -8.07554 -2526 6 21.2305 27.6771 4.7955 -18.4608 -25.795 -24.9287 -2527 4 20.5062 27.4644 5.39651 2.92048 5.31567 1.45057 -2528 4 20.941 27.2184 3.94502 12.5509 18.4099 23.8236 -2529 6 54.9409 17.9571 1.83459 -7.07205 6.42915 6.55936 -2530 4 54.7029 17.1381 1.42965 7.06691 -21.815 -7.49321 -2531 4 54.119 18.4405 1.74821 -9.38537 8.8513 -0.363257 -2532 6 36.7335 10.6984 6.58912 -34.5362 -0.324761 -4.53473 -2533 4 35.7609 10.9799 6.6143 34.1258 -12.1011 2.72213 -2534 4 36.7696 9.77633 6.90859 -3.13742 6.31851 -1.30765 -2535 6 54.2706 4.50024 14.0257 -11.269 5.99606 -15.4247 -2536 4 53.8536 5.11876 13.3604 4.87759 -11.992 26.1673 -2537 4 53.895 4.59469 14.9192 -3.76531 8.72829 -7.53187 -2538 6 22.107 12.8255 32.0148 27.0088 -6.82073 4.3703 -2539 4 21.2061 13.1328 31.8952 -10.7145 6.62508 -9.34344 -2540 4 22.7298 13.2576 31.3917 -17.4011 -3.99159 8.00208 -2541 6 15.2931 36.6619 4.04206 -24.4039 12.3238 20.1693 -2542 4 15.3606 37.6342 3.9855 6.08423 -9.62309 -2.22716 -2543 4 16.0243 36.2999 3.55051 12.1414 -1.28609 -8.9598 -2544 6 23.9518 1.27347 5.70825 1.82336 16.8815 15.3992 -2545 4 23.158 0.731739 5.71694 -5.31944 -7.03749 -3.2154 -2546 4 23.9846 1.73289 6.57368 -1.26671 -8.46254 -14.2674 -2547 6 14.3069 12.6571 15.8074 -11.3886 -13.8779 -22.9988 -2548 4 14.4908 12.4438 14.8835 17.1875 4.58775 1.43504 -2549 4 13.3991 12.3171 15.8566 5.60683 8.95198 18.2444 -2550 6 15.0463 40.2277 6.58272 -14.4539 15.1029 5.15073 -2551 4 15.8086 40.489 7.08192 22.3652 -6.01515 7.9389 -2552 4 14.4962 41.022 6.75392 -6.77819 -16.9793 -13.6053 -2553 6 48.5629 32.6194 12.091 2.37027 -5.84764 -3.4739 -2554 4 48.1048 31.8776 11.6348 7.57669 12.4587 1.43975 -2555 4 49.3373 32.9111 11.5511 -18.0393 -12.2542 5.39731 -2556 6 11.2883 31.5349 7.21941 -5.75599 -10.1169 -16.3625 -2557 4 10.675 30.8987 6.79271 12.7122 10.5617 8.56414 -2558 4 11.681 32.0415 6.48473 -4.52974 -6.63428 7.17241 -2559 6 30.1204 27.9925 10.216 2.65146 5.67665 0.571004 -2560 4 30.7332 28.7325 10.019 -7.63861 -11.6097 -0.594568 -2561 4 29.9063 27.5181 9.39417 2.857 4.22172 -1.33476 -2562 6 27.6817 22.1076 17.3717 2.13561 -8.21554 7.46684 -2563 4 27.3138 21.4721 16.7296 5.88092 9.15558 -3.1228 -2564 4 28.0594 22.8778 16.9197 -3.27829 -5.84867 -5.86393 -2565 6 12.9588 4.5965 18.1625 2.45174 -26.8216 -12.137 -2566 4 13.4346 3.75914 18.3684 -5.38503 16.4797 0.486183 -2567 4 12.5704 4.4145 17.2814 1.35975 11.1796 8.84538 -2568 6 19.7171 6.72206 19.0824 18.7149 18.1076 8.78634 -2569 4 19.0276 6.07043 19.1643 -12.8479 -14.7766 2.48779 -2570 4 20.149 6.78349 19.9504 -8.03044 -1.70313 -8.42964 -2571 6 37.158 31.386 11.4948 13.5333 -6.17925 -0.534196 -2572 4 36.3748 31.5241 12.0574 10.6691 -10.2998 8.4252 -2573 4 37.8298 30.7884 11.9154 -26.2348 9.80485 0.777976 -2574 6 3.12167 16.2038 27.3537 -19.2499 -26.3416 -14.9115 -2575 4 2.564 15.4232 27.613 17.9651 21.4634 -3.17821 -2576 4 3.05771 16.2343 26.3741 -0.0558506 5.44355 20.7735 -2577 6 15.7152 9.97508 38.3617 37.2659 20.4939 22.6587 -2578 4 16.1689 10.8384 38.1525 -17.0523 -25.976 5.55091 -2579 4 16.2475 9.64647 39.1327 -18.0975 2.21635 -20.7757 -2580 6 13.3945 14.2914 8.22355 52.7406 24.0557 20.8129 -2581 4 13.9343 15.0997 8.53617 -32.8018 -27.7376 -11.9171 -2582 4 14.0669 13.5802 8.35008 -24.0553 1.67412 -6.96019 -2583 6 1.72299 24.3133 36.3936 32.5837 -28.3335 21.1288 -2584 4 1.96116 25.1215 36.8464 -1.44419 12.4956 -1.11134 -2585 4 1.10799 24.5417 35.7277 -24.491 15.1488 -24.3141 -2586 6 11.1925 26.5189 32.9725 1.88857 3.23229 20.5962 -2587 4 10.9062 26.8258 32.1286 -6.138 -2.28585 -27.1412 -2588 4 11.0637 27.2989 33.5293 3.02186 -7.15206 7.83107 -2589 6 29.5898 0.769141 36.29 0.770047 10.6645 18.3277 -2590 4 29.1085 0.54227 35.5145 -3.81283 -13.529 -27.0487 -2591 4 28.8904 1.11515 36.8518 6.86702 4.29265 4.12775 -2592 6 43.6054 13.1224 23.9122 -2.46968 6.93561 -17.1322 -2593 4 42.8447 13.3401 24.4619 -4.47847 1.10283 0.728731 -2594 4 43.3126 13.2067 22.9653 4.50753 -0.208477 27.3689 -2595 6 7.45217 19.7807 19.6677 5.33955 -1.6221 -12.877 -2596 4 6.80427 19.1226 19.9251 -3.45906 -4.13396 8.35684 -2597 4 7.46466 19.745 18.7046 0.226191 5.91599 3.73904 -2598 6 24.4186 4.28854 7.83154 -9.27237 -3.93777 -5.86373 -2599 4 24.1141 5.19611 7.95791 2.72117 -5.11917 -0.666563 -2600 4 25.0574 4.07609 8.5187 1.73531 2.38301 -0.0162684 -2601 6 51.4783 30.2365 31.1578 4.43663 8.1051 17.8753 -2602 4 50.5719 29.9409 31.3316 -1.01079 -0.531629 -9.26743 -2603 4 51.6665 30.2531 30.2149 -6.58635 -1.64064 -12.0931 -2604 6 0.928618 23.6677 16.8891 39.1558 -2.20072 16.2176 -2605 4 0.0728448 23.4362 16.5368 -6.93512 -13.3273 -6.91209 -2606 4 1.45563 22.867 17.1505 -20.9828 13.2836 -9.64814 -2607 6 45.0876 19.3948 15.692 7.86589 27.8079 -34.4593 -2608 4 45.9117 18.9264 15.546 6.38244 -8.87865 2.87525 -2609 4 44.6429 18.9609 16.3882 -19.7965 -22.2098 30.8606 -2610 6 17.4975 8.71947 40.5884 -15.3884 33.6574 -8.04213 -2611 4 18.1832 9.38307 40.741 -0.0730079 1.31818 -0.306908 -2612 4 17.9142 7.90906 40.8182 15.4372 -26.466 6.58932 -2613 6 30.1853 27.2566 27.195 -12.9952 17.3445 1.1523 -2614 4 31.1231 27.467 27.0889 -0.851996 0.391463 0.93648 -2615 4 29.6983 28.1205 27.2412 18.1484 -22.709 -4.59112 -2616 6 43.0643 26.2027 28.3545 -5.31946 22.0639 -20.7107 -2617 4 43.281 25.753 27.5201 1.76973 -3.45008 6.18356 -2618 4 43.0898 25.5645 29.0616 2.35339 -12.574 6.70826 -2619 6 27.9963 7.58777 3.05558 10.5798 9.34284 19.8534 -2620 4 28.0446 6.83168 2.47717 -2.58104 -14.3156 -10.0889 -2621 4 28.509 7.35692 3.86128 -6.64638 2.01122 -8.68086 -2622 6 44.6822 7.22369 10.1895 -15.4824 21.4485 13.7445 -2623 4 44.4465 7.45383 11.1264 7.27839 -9.51736 -18.1425 -2624 4 45.2115 6.42757 10.2073 4.94307 -7.89984 8.76143 -2625 6 23.5336 20.3897 32.2571 -4.86538 -1.36788 -16.1605 -2626 4 23.3032 21.2113 32.7104 1.28111 0.523216 5.34569 -2627 4 23.9774 19.8232 32.8948 2.81274 0.218846 6.19737 -2628 6 37.5478 21.0473 29.278 -18.5062 7.79735 6.57819 -2629 4 37.2371 20.358 28.6908 4.72073 -14.165 -12.1471 -2630 4 36.7158 21.4163 29.628 13.2175 4.90017 2.66375 -2631 6 49.286 29.0703 28.699 10.8186 8.22027 -9.31733 -2632 4 48.7028 29.7991 28.456 -10.3299 -0.414367 -0.610456 -2633 4 50.1517 29.4276 28.433 0.637469 -9.81751 4.99071 -2634 6 47.52 18.1671 15.2208 -2.7229 30.7912 -34.1138 -2635 4 48.0078 17.7317 15.8928 12.2019 -13.0526 25.5862 -2636 4 48.0044 19.0008 15.0204 -10.6208 -16.322 3.06818 -2637 6 23.2448 11.1727 16.5931 -14.8157 -11.6244 -0.308602 -2638 4 23.8342 11.8286 16.2582 11.4387 21.3683 -6.30591 -2639 4 23.6559 10.3501 16.3116 -3.14365 -5.23997 2.15847 -2640 6 3.13911 8.33446 23.1963 -2.69702 8.14317 3.16076 -2641 4 3.4034 7.82956 22.4196 3.11719 -1.75335 -2.44085 -2642 4 3.61355 9.18537 23.1574 -2.855 -3.87959 1.25156 -2643 6 0.502965 16.1866 6.18545 3.06312 3.24934 37.7622 -2644 4 1.47856 16.2897 6.04903 -24.0003 -4.70784 4.68468 -2645 4 0.309706 16.1237 7.18858 13.4295 2.89967 -42.1744 -2646 6 43.1771 15.7066 5.83749 -5.07319 -7.51407 -5.60477 -2647 4 43.0136 16.4204 6.43488 -7.5966 11.2789 14.4199 -2648 4 44.0623 15.8898 5.5251 15.5631 0.134699 -7.60204 -2649 6 16.7019 35.4798 34.4572 -11.2013 7.16284 28.6023 -2650 4 15.9782 34.9492 34.0738 5.35466 1.61493 8.45244 -2651 4 16.3895 35.7941 35.362 6.52255 -9.83405 -29.4813 -2652 6 38.8822 7.74245 15.6771 24.467 26.2162 11.5837 -2653 4 39.1941 7.06316 15.0707 0.325231 -3.95447 -5.25413 -2654 4 39.6937 8.2709 15.9758 -30.2905 -22.5291 -12.0432 -2655 6 42.0043 36.5204 13.6369 3.57579 19.2035 0.0265624 -2656 4 41.9371 35.5667 13.6578 -6.58441 -9.91584 1.38486 -2657 4 41.1548 36.8737 13.3269 0.670997 -7.61264 0.497391 -2658 6 54.2965 15.3698 32.1203 7.94984 -1.57724 11.6593 -2659 4 0.00278476 15.9714 32.4364 -1.97539 -6.90512 -0.0853595 -2660 4 53.6257 15.9484 31.7567 -4.83125 0.736868 -4.95397 -2661 6 22.8953 13.994 39.0277 29.317 0.766946 3.70607 -2662 4 23.2673 14.8115 39.3939 -3.87119 -6.48985 -1.20924 -2663 4 21.9724 14.1463 38.894 -27.0425 2.87882 -4.26486 -2664 6 48.0413 28.5291 4.79053 -11.6037 -2.58599 22.6989 -2665 4 48.6027 28.7991 4.07655 16.555 3.34212 -19.6439 -2666 4 47.7045 29.3636 5.15455 0.064426 -0.719185 3.47056 -2667 6 48.8324 10.6079 2.66689 -4.06073 -3.45613 -38.269 -2668 4 48.225 10.1372 3.21562 -13.339 -11.2438 14.6703 -2669 4 49.3888 11.1314 3.20945 16.7197 17.33 23.918 -2670 6 17.1017 29.3417 4.42129 -6.1746 1.2215 19.6287 -2671 4 16.2515 28.9749 4.73431 4.06151 0.983408 -5.41825 -2672 4 17.5169 29.7258 5.22535 1.37581 -6.66399 -13.2687 -2673 6 27.7925 7.31966 26.5665 39.3465 35.5797 -5.30427 -2674 4 28.7629 7.09708 26.703 -34.5848 -6.71948 -0.628584 -2675 4 27.2286 6.57009 26.6643 -1.86949 -31.2701 4.24572 -2676 6 18.0221 22.0409 22.5172 -16.5701 10.2349 -21.3339 -2677 4 18.5639 21.2383 22.5163 -1.8186 -3.43948 -8.36361 -2678 4 17.5144 22.1102 21.6408 22.068 -10.0871 32.2991 -2679 6 22.1395 25.0891 16.7042 -20.9036 23.9116 7.05274 -2680 4 21.7854 25.6501 15.9625 11.5166 -19.4533 18.3362 -2681 4 22.5191 24.3092 16.3181 5.92374 -8.20656 -11.3677 -2682 6 25.488 28.4523 7.12785 -10.8823 -15.9396 20.8595 -2683 4 25.4981 28.5494 8.12476 3.48758 8.16016 -33.1398 -2684 4 25.5521 29.3092 6.69674 -1.4246 11.8198 7.49476 -2685 6 42.5416 24.7341 23.7389 -17.4504 20.5814 2.46415 -2686 4 41.7374 25.1978 24.1118 21.637 -12.0739 -8.95046 -2687 4 42.3838 23.7928 23.8344 -7.43983 -12.597 1.84916 -2688 6 6.22002 16.6178 2.47863 15.1987 22.5956 5.3052 -2689 4 5.33799 17.0017 2.41879 -13.1624 -14.3434 -0.0608379 -2690 4 6.24934 15.6649 2.55192 -10.5885 -12.312 -0.729605 -2691 6 47.3735 33.281 1.45237 -1.26376 -9.34891 -34.4477 -2692 4 47.004 34.1558 1.53803 -0.151384 8.42018 6.19826 -2693 4 47.7374 33.0316 2.29181 5.29029 2.56444 17.845 -2694 6 1.28124 36.1882 24.8833 15.6174 10.404 -23.7919 -2695 4 0.591937 36.4933 25.4703 -7.67557 -4.15788 11.0948 -2696 4 1.63511 35.375 25.2549 -3.92235 -3.89482 10.8998 -2697 6 20.9296 29.0485 16.4244 -14.8946 8.72798 0.140185 -2698 4 21.4494 28.4837 15.8729 6.14594 -21.5718 -11.6475 -2699 4 21.5122 29.7657 16.643 5.64358 11.2813 6.66084 -2700 6 18.6504 32.5428 14.1464 30.5599 1.70581 -2.73789 -2701 4 17.8579 33.056 14.2705 -20.3424 -4.20043 8.80032 -2702 4 18.5989 31.5954 14.3835 -16.0449 10.8642 1.76069 -2703 6 15.729 41.6925 0.00385817 -5.28292 -15.868 -0.0471225 -2704 4 15.6317 41.084 41.1283 -1.722 11.921 23.9575 -2705 4 15.1873 41.3899 0.782005 8.67232 1.52126 -23.9336 -2706 6 20.5292 18.4098 7.21323 -2.91221 4.89049 5.17577 -2707 4 20.2914 18.5583 8.16487 -5.028 -0.721877 -18.2737 -2708 4 19.7413 18.3526 6.62958 8.30767 0.291632 18.8261 -2709 6 35.3342 2.82915 1.61883 3.51298 26.3767 19.1091 -2710 4 35.0331 3.19583 2.50754 16.3791 -7.36031 -35.2043 -2711 4 35.9206 3.53855 1.22039 -16.4006 -18.5858 14.5973 -2712 6 48.9922 19.6721 24.94 -34.075 0.0390245 -1.22883 -2713 4 49.8199 19.2352 24.7823 16.5976 -0.114011 -0.96393 -2714 4 49.1617 20.6125 25.0649 5.94448 -3.86752 4.03728 -2715 6 26.0294 7.18427 41.5679 18.6543 -22.0446 -14.9111 -2716 4 26.7755 6.56315 41.735 -11.6555 11.6244 -4.08136 -2717 4 25.6575 7.3193 0.515359 -11.3234 5.2253 22.1616 -2718 6 22.0232 3.61039 29.0191 -5.74486 -2.38085 -7.46091 -2719 4 21.2539 3.82496 28.4513 11.98 3.27859 6.66273 -2720 4 22.2148 4.35673 29.5966 -4.60401 3.08527 0.791206 -2721 6 27.8512 32.5337 20.6565 16.709 -10.0789 14.6393 -2722 4 26.9625 32.7469 20.4552 -34.4793 1.21347 -3.16249 -2723 4 28.3469 33.1233 20.1026 12.1012 5.18966 -5.24336 -2724 6 8.41229 24.7869 3.46082 22.3386 15.1563 9.53263 -2725 4 8.90357 24.2552 2.84068 9.55631 -8.44952 -10.853 -2726 4 7.60423 24.3318 3.61908 -22.8615 -12.1417 2.22131 -2727 6 30.5897 41.7312 15.6484 22.6974 7.2585 28.5546 -2728 4 29.9644 0.0840213 16.3484 1.9076 -3.76769 -8.41354 -2729 4 30.1014 41.5664 14.8669 -20.7398 -7.21626 -25.2002 -2730 6 48.088 5.62638 21.1953 6.60529 -8.20232 0.106871 -2731 4 47.6746 6.34733 20.7055 -8.23977 -5.05625 1.96425 -2732 4 47.4017 5.06013 21.5879 -0.150274 10.975 -6.21391 -2733 6 39.4216 23.1741 35.7526 -24.6601 -13.9913 -21.1364 -2734 4 39.9113 23.6202 36.3986 28.8985 24.9348 33.8823 -2735 4 38.8958 22.5444 36.2533 -4.57276 -5.65639 2.90172 -2736 6 51.5794 33.3637 5.78804 -15.2387 -43.0642 -16.4958 -2737 4 51.7543 34.264 5.94613 8.32006 43.2545 8.99501 -2738 4 51.5314 33.243 4.82206 1.27667 3.09716 8.04215 -2739 6 40.1245 17.6149 30.7901 8.56984 -3.86721 -1.09973 -2740 4 39.7659 18.4612 31.0527 -2.58034 0.199434 5.42908 -2741 4 40.7245 17.8709 30.0792 -0.880063 -10.8459 -3.09375 -2742 6 46.409 9.80599 18.5787 -10.6525 10.5445 16.3312 -2743 4 47.1858 10.3579 18.4839 1.73901 1.20814 1.97642 -2744 4 46.4156 9.2339 17.8265 -1.18405 -17.3223 -19.0152 -2745 6 15.8964 41.084 31.9275 -7.67529 -16.3413 6.36199 -2746 4 16.5726 40.6297 31.3851 0.744388 15.1086 2.48527 -2747 4 16.0838 0.121849 31.9545 10.6182 0.477469 -6.79561 -2748 6 48.5579 25.7373 14.9245 -32.9201 0.62376 14.4593 -2749 4 49.4842 25.8337 14.7718 19.5896 2.21134 -17.0603 -2750 4 48.049 25.8802 14.1037 15.4245 2.93063 1.46628 -2751 6 39.2312 28.9787 36.1455 -14.672 -4.00104 3.01304 -2752 4 39.9934 29.3216 36.628 6.25522 6.25199 -7.03146 -2753 4 39.4638 28.7366 35.2366 10.4577 0.0924929 -3.6403 -2754 6 37.3289 21.0516 14.9314 -10.8689 -7.09111 1.49701 -2755 4 38.071 20.892 14.3011 -28.0288 10.0477 -1.14031 -2756 4 36.4673 21.3942 14.5393 36.2132 -8.93414 7.14583 -2757 6 32.4934 22.8531 15.7417 3.10645 -11.4389 20.7178 -2758 4 31.7266 22.539 15.2235 4.17967 -1.79737 6.20971 -2759 4 32.6084 22.2825 16.5528 -7.19864 12.5613 -26.7488 -2760 6 18.5678 8.15053 37.5885 12.1963 17.253 1.38788 -2761 4 19.2402 8.85275 37.7813 -15.6951 -12.294 2.78452 -2762 4 17.9606 8.11124 38.3342 2.60008 5.05619 4.87993 -2763 6 46.9436 30.3797 11.0104 1.88703 -1.83756 -2.66296 -2764 4 46.4577 30.6986 10.2121 16.8565 -15.5671 12.8865 -2765 4 47.4104 29.5424 10.7815 -11.8828 15.01 -3.66074 -2766 6 54.6316 13.0448 30.6676 -4.47091 -6.8042 2.85617 -2767 4 54.8929 12.2323 31.1402 -1.2342 7.60269 0.15722 -2768 4 54.6603 13.771 31.309 -0.297949 0.849652 -1.52079 -2769 6 32.2951 35.1224 27.9786 -1.77947 21.9995 15.3623 -2770 4 32.2792 35.8643 28.662 -2.01418 -27.5067 -15.3374 -2771 4 32.1621 34.2527 28.3767 0.559318 -0.0892981 14.8897 -2772 6 4.45055 25.4036 31.7899 -1.02142 -16.2715 16.4968 -2773 4 4.99753 24.9958 32.4777 -6.33224 -6.47315 3.67169 -2774 4 4.91071 26.2154 31.6821 9.55032 31.2277 -12.9728 -2775 6 40.7771 38.1434 21.8579 6.80518 1.6634 -4.63259 -2776 4 40.7449 39.0581 22.1203 -10.5616 15.8809 15.9679 -2777 4 41.4448 38.2055 21.1733 6.63637 -13.627 -11.1518 -2778 6 26.6799 9.85647 27.3982 -25.6987 30.8747 18.2417 -2779 4 27.0738 9.12687 26.9584 7.64189 -30.2216 -11.3166 -2780 4 25.7862 9.62595 27.7363 13.5029 -2.01996 -6.34848 -2781 6 53.4177 39.431 11.7682 60.4327 6.90374 -14.3662 -2782 4 54.4363 39.4906 11.5459 -51.7213 -2.15349 13.0324 -2783 4 53.0514 40.2823 11.4531 3.65586 -10.6921 6.91198 -2784 6 35.3318 21.4177 2.24537 5.41769 -12.1321 -20.1082 -2785 4 34.8431 20.6225 2.51379 1.47903 7.83344 1.83382 -2786 4 35.7036 21.1864 1.3528 -11.9529 6.47568 24.5243 -2787 6 4.13637 17.136 33.9211 3.37621 -12.3766 5.67686 -2788 4 4.20441 16.396 34.5697 -7.88327 11.3141 -11.775 -2789 4 3.23668 17.1493 33.5445 4.32036 -6.23827 5.33579 -2790 6 24.1551 16.173 14.6595 0.905264 -13.203 -15.7913 -2791 4 24.2344 17.0724 14.9677 3.21898 8.1818 3.14137 -2792 4 23.7074 16.2777 13.8038 1.81958 -4.41422 2.08172 -2793 6 43.135 2.84466 26.1032 13.1229 6.35408 -5.68313 -2794 4 42.2875 3.17639 26.414 -4.49653 4.08553 -4.30298 -2795 4 43.2684 3.17059 25.1875 -5.24638 -3.17663 12.7173 -2796 6 40.6938 12.184 1.56501 -11.5288 -7.07153 -25.6549 -2797 4 41.6237 12.1687 1.8186 -0.151998 5.09311 17.9246 -2798 4 40.0653 12.4844 2.24465 11.7671 0.703669 4.7582 -2799 6 47.3771 8.09383 26.755 61.1653 27.2124 16.0462 -2800 4 46.6352 7.69428 26.3774 -33.8593 -24.2939 -29.8281 -2801 4 48.1554 8.02079 26.1437 -24.5213 -4.41693 14.2109 -2802 6 35.8722 30.7298 38.4929 46.7797 8.20249 -0.795626 -2803 4 35.8437 29.9971 39.0885 -23.8052 -20.0767 8.1402 -2804 4 36.8495 30.8926 38.5637 -31.083 11.8011 -18.5205 -2805 6 51.2951 23.2205 32.4921 -21.4102 17.5258 -2.96787 -2806 4 51.6315 24.0445 32.1105 -0.705735 5.94923 -0.836877 -2807 4 52.0737 22.714 32.6486 16.7198 -16.4886 4.04233 -2808 6 30.6141 4.4461 39.6711 -15.3731 3.79473 -35.0115 -2809 4 30.9464 3.61986 40.0176 9.77962 -4.83986 19.2734 -2810 4 30.7704 5.18568 40.2576 9.11216 5.26318 14.244 -2811 6 35.2646 29.7051 2.85778 -14.8887 -12.395 -20.7058 -2812 4 35.7986 29.7272 2.02588 -11.2321 -1.99949 14.2373 -2813 4 34.4405 29.1492 2.64359 32.9241 21.0754 6.44042 -2814 6 50.3111 26.1454 9.40098 -22.1621 10.9454 -20.0185 -2815 4 49.986 26.7793 8.71172 15.2241 -16.6208 13.1315 -2816 4 49.7063 25.388 9.31525 11.793 4.08785 3.97386 -2817 6 50.0869 36.8245 26.4088 -20.9012 -6.38176 7.71076 -2818 4 49.5586 36.0705 26.7514 3.9746 5.79943 -8.74909 -2819 4 50.1941 37.3864 27.1871 4.41306 8.36789 0.548966 -2820 6 40.3119 23.9565 38.5384 47.4279 -1.39254 -15.5521 -2821 4 40.88 24.732 38.748 -21.3925 -13.0784 -2.40019 -2822 4 39.4343 24.1145 38.8527 -20.1214 13.5622 11.7594 -2823 6 24.9444 10.7496 30.6663 31.051 18.5451 27.0394 -2824 4 25.7305 10.8456 31.2787 -28.4 -7.1047 -26.2292 -2825 4 24.8995 11.6269 30.2371 -7.15612 -14.1049 -2.61146 -2826 6 5.89131 1.01728 5.39947 -5.16247 -17.9253 -0.227043 -2827 4 5.22088 0.340863 5.59281 2.49468 7.88844 1.50452 -2828 4 6.71299 0.544267 5.57411 4.99832 4.76302 -4.28882 -2829 6 44.2927 29.3807 26.2764 43.728 -18.4205 -0.18667 -2830 4 43.5018 29.5461 25.816 -39.4067 7.83222 -12.62 -2831 4 44.7851 28.7616 25.699 -3.50466 6.32584 16.51 -2832 6 25.3064 10.1814 6.6654 -6.94402 -15.718 -9.61204 -2833 4 25.6542 11.0594 6.61048 6.10034 18.8978 1.37462 -2834 4 25.5624 9.77067 5.8255 0.943829 -2.29537 1.40094 -2835 6 13.3606 28.0664 2.58456 21.0736 -2.27515 1.79417 -2836 4 12.4645 27.8304 2.42125 -25.9451 -0.745297 2.44011 -2837 4 13.7867 27.7237 1.79619 10.8353 3.06046 3.23802 -2838 6 6.45257 40.24 18.0133 20.0379 8.33657 1.98834 -2839 4 6.89988 39.3931 17.8777 -5.14522 -3.62214 0.392952 -2840 4 5.56311 40.1207 17.6969 -15.0406 -3.82351 -6.06839 -2841 6 47.8011 13.5056 2.01844 -10.5648 -21.267 23.3214 -2842 4 48.1524 12.6081 2.17165 -2.87721 6.43796 -2.24674 -2843 4 48.4275 13.9546 1.48105 20.9852 11.6376 -18.273 -2844 6 13.5939 20.3067 2.43603 17.8956 14.689 14.157 -2845 4 13.8339 19.6256 3.09172 -4.40777 3.66463 -6.9739 -2846 4 12.9598 19.9059 1.86118 -14.8369 -10.3601 -11.305 -2847 6 15.2334 0.8368 36.6591 1.55142 7.70692 -22.3998 -2848 4 15.2542 1.38367 37.4773 0.960764 -3.32816 -20.1037 -2849 4 15.3344 1.45306 35.8608 -4.23652 -17.7771 37.8382 -2850 6 33.6147 35.2459 15.1 16.7734 -11.8793 -18.4599 -2851 4 33.8163 35.2873 16.0538 13.2499 -3.34836 -12.9991 -2852 4 34.4154 34.9808 14.5294 -23.6504 9.8312 34.8639 -2853 6 21.8005 9.23588 0.431159 13.8262 -19.7524 30.0596 -2854 4 22.4067 9.05801 41.6249 5.27322 -0.932182 -12.5411 -2855 4 21.1072 9.74412 0.0564903 -22.836 18.1195 -16.0408 -2856 6 38.1565 27.4627 3.04439 18.4183 -28.2807 7.84104 -2857 4 37.7322 27.3164 2.21113 -4.60599 -14.2952 -24.3043 -2858 4 37.7632 28.2451 3.34335 -13.6136 36.2365 19.5187 -2859 6 38.8873 27.196 11.7739 15.5044 -8.33717 -5.93911 -2860 4 38.7841 26.3327 12.232 6.37868 6.61944 -11.5261 -2861 4 39.5786 27.1133 11.0659 -17.5863 -8.28826 19.2684 -2862 6 29.8757 41.5959 28.7066 13.5858 28.49 -11.3766 -2863 4 28.9647 41.3014 28.7466 -9.40406 -2.02578 1.88502 -2864 4 29.8997 0.254331 27.9025 -2.68961 -11.7418 13.302 -2865 6 34.0266 8.72323 38.0698 33.719 9.40995 4.6971 -2866 4 34.8877 8.24089 38.094 -11.378 13.1352 -1.62724 -2867 4 33.3712 8.08689 37.8245 -20.4874 -15.945 -8.86187 -2868 6 38.8142 27.3472 30.6886 -7.48306 -22.0573 -0.58069 -2869 4 38.4096 26.5151 30.3537 9.19692 16.3236 1.53567 -2870 4 38.2655 27.5885 31.4334 -4.0026 6.56393 5.14207 -2871 6 41.6513 17.2644 36.3568 8.49285 18.5772 4.12306 -2872 4 41.236 17.1887 35.5016 -7.55839 -3.54967 -10.3568 -2873 4 41.7813 16.3888 36.7033 1.22956 -17.0266 1.65102 -2874 6 30.7157 26.9788 35.2038 -10.151 -4.28381 0.0670681 -2875 4 31.4488 27.4236 34.7965 20.0965 0.384289 -13.2747 -2876 4 30.343 27.6484 35.7639 -8.80839 6.96039 12.3672 -2877 6 47.5342 4.10778 27.2888 11.6095 8.93875 26.3727 -2878 4 46.6105 4.27591 27.501 -8.38331 -0.425724 -4.8003 -2879 4 47.5988 3.99389 26.3497 -6.2541 -0.220522 -17.1995 -2880 6 20.9412 8.38521 7.26575 -18.1268 -17.2637 2.68033 -2881 4 20.8809 8.87169 8.08328 -6.592 1.96128 21.9757 -2882 4 21.4179 8.98778 6.73029 19.5174 18.1449 -30.7672 -2883 6 36.8608 13.6781 0.872276 -22.567 18.0135 -7.8322 -2884 4 37.3857 13.5342 1.64823 18.2236 -14.2068 17.6988 -2885 4 36.9649 12.9376 0.269125 7.56106 -9.0363 2.17502 -2886 6 28.5805 20.3012 26.4498 13.4935 0.222411 -13.7489 -2887 4 28.4835 19.3803 26.2016 0.90122 -3.21423 2.30104 -2888 4 27.7964 20.5416 26.9224 -18.5183 5.12398 12.3317 -2889 6 51.6021 16.8515 33.5179 -11.2544 -15.3 0.627003 -2890 4 51.563 16.0241 34.0301 0.916298 4.09207 -0.753195 -2891 4 51.0058 16.6639 32.7753 6.31462 4.20327 -0.345536 -2892 6 16.2626 32.019 37.6812 -31.2107 -29.2496 -22.9287 -2893 4 16.4537 31.3803 38.4011 -2.23747 12.829 -12.3594 -2894 4 15.5373 31.5705 37.1079 31.9743 21.1891 23.5065 -2895 6 14.3366 25.8859 13.2055 -16.2598 35.1345 -7.65407 -2896 4 13.5591 26.1022 13.7538 4.79106 -9.45955 4.66587 -2897 4 14.3924 26.7004 12.6499 8.67511 -16.0651 4.90492 -2898 6 54.9632 28.863 3.30225 1.80665 -46.0259 4.02989 -2899 4 54.8334 28.8705 2.33571 2.30679 -1.29159 7.0988 -2900 4 0.250446 27.9134 3.53944 -11.9885 37.0888 -10.0107 -2901 6 17.2065 5.13222 2.58226 -24.5489 -19.7693 -14.9516 -2902 4 17.8239 4.45011 2.8785 5.4716 1.45995 5.40018 -2903 4 17.4096 5.93537 3.0482 10.2082 3.99522 6.08435 -2904 6 50.7076 33.0524 10.3335 3.48719 10.0002 9.95533 -2905 4 50.6136 33.804 9.75033 0.0726689 14.8217 2.89741 -2906 4 50.6632 32.3255 9.72979 -1.7797 -23.5385 -6.20373 -2907 6 28.8719 19.8379 32.3662 12.2168 9.43689 -9.94144 -2908 4 29.8293 20.0527 32.223 -26.7315 -2.75674 4.09206 -2909 4 28.3919 20.677 32.2058 6.96369 -8.55206 2.54368 -2910 6 22.4258 12.8301 23.3099 -21.9068 12.8519 23.6974 -2911 4 22.5424 12.4187 24.2055 -3.2327 9.70973 -17.8182 -2912 4 21.6904 13.4906 23.4219 18.0295 -16.5223 -3.23075 -2913 6 54.7859 15.5473 8.87871 3.42684 8.57095 -7.37477 -2914 4 0.5152 15.244 9.45304 -3.41058 -4.28924 6.32649 -2915 4 53.9742 15.1056 9.16818 6.16615 -2.4265 3.01646 -2916 6 10.455 19.2982 26.169 33.281 -8.93788 40.2277 -2917 4 11.227 18.6906 26.1605 -15.5014 12.2348 -4.03004 -2918 4 10.0694 19.2521 25.3251 -19.4777 -1.76614 -41.28 -2919 6 38.6541 20.3016 35.2246 25.1317 -2.89776 0.584273 -2920 4 39.6122 20.389 35.0245 -16.8563 1.20482 1.7302 -2921 4 38.6037 19.6498 35.9401 -3.42784 5.37932 -3.92632 -2922 6 17.4847 18.0451 15.2473 -2.11698 43.6037 15.5575 -2923 4 17.3165 17.6253 14.4157 -4.81229 -12.7227 -25.2707 -2924 4 17.3243 19.0143 15.0283 6.45297 -29.0578 8.37137 -2925 6 29.6412 0.96029 26.2538 -2.92598 -32.1867 -14.968 -2926 4 29.2295 1.80722 25.9783 -5.05853 -19.2177 -5.0061 -2927 4 29.2302 0.136786 25.7855 11.2507 47.838 14.1271 -2928 6 30.4583 12.6781 28.2933 9.80318 -11.3268 12.128 -2929 4 29.9046 13.1756 27.6811 -9.35495 -4.05719 -6.55314 -2930 4 30.1425 11.7563 28.3949 -4.92949 12.905 -7.65094 -2931 6 36.6582 22.1039 33.3564 18.5548 3.44171 -30.7077 -2932 4 37.613 21.8793 33.4826 -21.695 5.78572 4.26475 -2933 4 36.1698 21.8632 34.1249 -2.38139 -6.6943 29.4942 -2934 6 34.851 22.4634 14.295 34.3706 -12.4795 -36.6647 -2935 4 34.1306 22.5878 14.8998 -26.9044 -0.864951 1.69223 -2936 4 34.6097 22.0485 13.4154 -10.7342 10.9778 31.0087 -2937 6 15.5278 9.60588 7.43972 42.9889 -30.8008 -13.2318 -2938 4 16.5289 9.52064 7.17624 -51.4641 3.68278 11.9177 -2939 4 15.1523 8.68078 7.51431 10.3517 24.0811 1.24627 -2940 6 21.8097 28.0449 19.8036 -9.3837 2.2861 -3.69714 -2941 4 21.8234 28.4749 20.6579 1.49564 5.45585 8.79124 -2942 4 20.892 27.7474 19.715 3.3935 -2.50466 0.747966 -2943 6 34.5377 24.4067 2.43307 17.6783 -35.0943 7.08511 -2944 4 34.5604 23.3833 2.29911 9.6022 45.0517 12.0591 -2945 4 35.2671 24.6922 3.07368 -22.5652 -15.0324 -19.8681 -2946 6 12.5974 20.9324 33.5156 -46.2472 -18.3539 -4.34371 -2947 4 11.7028 20.621 33.8238 24.9199 8.0821 6.3307 -2948 4 12.4411 20.8933 32.5604 17.1824 5.4367 5.76912 -2949 6 45.7726 31.1546 8.70236 -14.9606 25.5026 -0.599968 -2950 4 45.9029 32.1319 8.75243 4.68257 -18.3747 -3.63409 -2951 4 44.8252 31.0158 8.86685 6.58294 -2.27884 -1.49072 -2952 6 15.4856 22.546 30.183 -27.3843 -7.95278 -8.87715 -2953 4 16.2041 23.1276 30.4314 15.0704 -4.03687 4.09321 -2954 4 15.7065 21.6006 30.174 10.2057 11.8959 3.83923 -2955 6 39.7496 17.1848 38.4183 10.7213 7.86871 6.49434 -2956 4 39.4778 16.5926 37.6964 5.17631 5.73732 3.80123 -2957 4 40.5328 17.6892 38.1152 -12.3514 -12.5856 -1.70264 -2958 6 14.0114 24.6894 0.67727 2.36324 3.45559 -2.63023 -2959 4 14.2236 24.5974 1.61702 0.728832 5.12592 -0.706901 -2960 4 14.3876 25.5307 0.374588 3.08684 -2.75846 6.71077 -2961 6 31.517 19.5744 3.57234 -39.7066 16.7987 -9.47084 -2962 4 30.9812 19.3042 4.35775 22.6375 1.42354 -10.5596 -2963 4 32.4299 19.3292 3.64982 19.3858 -12.3464 7.87151 -2964 6 36.0836 25.0594 19.4567 -36.7914 6.39304 28.0525 -2965 4 37.0156 25.1955 19.4145 23.7106 3.97855 -3.98164 -2966 4 35.8434 24.7134 18.6052 0.797557 -6.28507 -17.3783 -2967 6 51.6689 17.6827 14.8094 17.1445 12.5774 26.8045 -2968 4 51.9037 18.5572 15.2299 -9.72171 -22.1194 -12.5657 -2969 4 51.1779 17.9239 14.0295 -8.26923 9.08158 -15.405 -2970 6 37.7112 27.5006 38.1887 12.9616 35.4771 9.449 -2971 4 37.6633 26.7956 37.5532 1.11487 -12.4995 -15.1422 -2972 4 38.1924 28.2458 37.7567 -11.1334 -22.4905 3.32353 -2973 6 34.7974 13.8528 30.7792 38.2139 14.8122 -13.8353 -2974 4 35.0479 14.6237 31.2931 10.1718 6.91547 -1.09557 -2975 4 34.0108 13.6012 31.1887 -47.9834 -23.6229 17.9792 -2976 6 19.6227 37.378 39.9679 -4.73731 -6.94245 -18.3615 -2977 4 20.5687 37.4692 40.1123 7.88808 5.09103 7.87528 -2978 4 19.5641 36.8976 39.1176 -6.21843 3.50671 7.67834 -2979 6 40.9479 34.0678 21.4433 -0.249567 -14.1225 -18.8789 -2980 4 41.1016 33.9428 22.3797 -2.14769 -1.67588 5.36328 -2981 4 40.6839 33.1793 21.1286 -1.36491 12.9737 -0.808456 -2982 6 32.9563 27.2052 26.5619 16.765 25.3633 38.6423 -2983 4 33.6584 27.782 27.0193 -28.2502 -21.1678 -18.3317 -2984 4 33.3196 26.985 25.7164 10.2198 -2.00428 -21.725 -2985 6 24.4119 18.6722 15.6191 2.60565 2.56356 0.790403 -2986 4 23.5591 19.1036 15.7005 -5.06369 4.62453 -0.705819 -2987 4 24.5532 18.2558 16.4735 3.02917 -4.75652 8.16225 -2988 6 29.9677 1.63803 9.07283 -8.6377 39.5876 -9.34009 -2989 4 30.0634 0.720354 9.20948 2.18912 -36.9171 5.61628 -2990 4 29.1461 1.70687 8.54641 9.48634 -0.985828 6.78106 -2991 6 31.4838 20.0989 7.86304 35.53 0.0326438 -30.7549 -2992 4 32.0429 19.6076 7.17649 -26.3889 9.76992 30.1887 -2993 4 30.8408 19.4752 8.19414 -7.49558 -12.7978 -1.24617 -2994 6 35.0504 3.77818 33.2765 0.0823497 -0.922868 12.9261 -2995 4 34.3448 4.25588 32.7981 8.7563 -3.59111 2.91721 -2996 4 34.8655 3.9194 34.2319 -2.64551 -3.11561 -17.2257 -2997 6 43.9652 7.96842 12.9746 -1.99776 -12.8019 0.966431 -2998 4 43.3695 7.30717 13.3748 13.3395 3.08022 -2.86187 -2999 4 43.3917 8.71398 12.8108 -3.39849 12.2944 -1.42541 -3000 6 44.1076 32.6848 16.9531 4.83347 14.0385 -4.8226 -3001 4 44.7886 33.3699 16.7553 -9.08835 -13.3706 7.91806 -3002 4 44.1269 32.547 17.9059 1.63547 3.97279 4.50154 -3003 6 40.604 27.1617 19.037 5.49217 0.683783 -24.0967 -3004 4 39.907 26.5243 18.7614 10.7357 10.4426 0.818988 -3005 4 41.0572 27.5561 18.2306 -16.7517 -14.1941 23.9583 -3006 6 46.0503 23.2068 29.0603 33.2935 27.7725 23.492 -3007 4 46.7239 23.8517 29.4252 -26.0483 -15.0892 -12.6312 -3008 4 46.5249 22.3737 28.9794 -1.25341 -9.22801 -2.13192 -3009 6 42.6264 30.606 18.8462 -34.271 -0.881878 -8.8004 -3010 4 43.5242 30.7893 19.1074 18.3218 -5.88078 -5.57768 -3011 4 42.5428 29.9264 18.1492 10.4183 2.57162 5.03187 -3012 6 36.1231 10.8975 23.2614 14.248 33.6052 6.96597 -3013 4 35.2264 11.248 23.1278 1.11349 -2.62395 -2.03304 -3014 4 36.6438 11.7125 23.5215 -18.5882 -27.5405 -10.5609 -3015 6 13.7387 31.5187 15.7175 -8.63655 -3.85126 -4.64142 -3016 4 14.6788 31.7096 15.8046 0.813603 4.25462 -2.48371 -3017 4 13.3439 32.0503 15.0041 7.14664 -1.81478 4.34843 -3018 6 33.1663 41.4263 27.7844 10.1514 -8.73892 50.1834 -3019 4 33.0558 0.0915148 27.0508 0.335607 20.6114 -25.4934 -3020 4 33.386 0.0476391 28.6 -4.59167 -12.6797 -24.4066 -3021 6 32.8924 22.9248 31.4777 14.8331 -14.2772 -3.0724 -3022 4 32.331 22.9976 30.6823 -4.11553 14.0534 8.76104 -3023 4 32.7731 23.648 32.1168 -12.639 5.72297 -14.9522 -3024 6 27.6514 16.8629 6.392 5.9792 -3.02818 28.7598 -3025 4 27.8554 17.3015 5.57876 -0.492343 9.99532 -20.1105 -3026 4 26.7867 16.4634 6.29535 -11.4685 -3.6273 -5.68351 -3027 6 47.2692 11.6326 26.0701 -7.51592 -12.561 -4.95541 -3028 4 47.0451 11.5188 27.0189 12.1951 16.3083 -15.426 -3029 4 47.7234 12.4489 25.7723 -5.45211 -2.19527 19.0308 -3030 6 27.5533 7.05227 7.64253 19.1893 -9.34804 28.5196 -3031 4 26.7486 7.45205 7.94122 -22.9318 8.15137 -1.85106 -3032 4 28.0959 7.04706 8.46187 -1.51515 -0.839126 -23.0353 -3033 6 39.7861 9.0687 11.9758 -15.1444 6.22431 -7.98147 -3034 4 39.495 9.25597 11.0599 4.77492 -2.72739 13.3066 -3035 4 38.9879 9.23938 12.5098 3.46881 -0.389139 -2.20355 -3036 6 18.1894 33.4728 36.1008 -27.5283 -9.1571 7.06889 -3037 4 17.6722 33.9726 35.425 4.94426 -9.47891 13.9641 -3038 4 17.5468 32.9442 36.6812 19.6546 19.0371 -24.2711 -3039 6 37.1945 26.5569 0.720807 -12.4444 8.19753 -2.53971 -3040 4 37.3568 25.6462 0.476597 4.7119 -6.04631 0.679389 -3041 4 36.2336 26.6328 0.585525 8.76389 3.8419 -0.879611 -3042 6 44.2004 19.6233 36.8917 26.7932 -13.3754 0.0595121 -3043 4 45.0387 19.0956 36.766 -19.227 18.7818 5.02367 -3044 4 44.4376 20.5683 36.9644 1.27086 -9.01627 -1.91077 -3045 6 27.7799 6.35317 35.6882 16.2858 -3.70231 1.18314 -3046 4 27.1634 6.96571 35.2926 -9.46908 3.45363 -4.90602 -3047 4 27.3042 5.53742 35.858 -2.00694 0.00942349 2.38052 -3048 6 34.7653 16.4924 20.8795 20.4023 -19.0949 10.3746 -3049 4 35.5516 15.8729 20.9898 -30.5098 25.2475 -4.70775 -3050 4 34.1298 16.2162 21.5757 7.90375 5.70636 -13.0995 -3051 6 39.0303 20.9673 40.4307 -20.4786 -67.2325 12.8224 -3052 4 38.8254 20.089 40.9106 11.5443 40.6977 -30.184 -3053 4 39.2642 21.5386 41.1412 8.11615 27.562 18.514 -3054 6 10.8068 27.9205 1.65866 27.4379 7.91142 -24.506 -3055 4 10.0967 27.7204 2.22826 -30.9372 -12.069 25.0324 -3056 4 10.8782 28.8813 1.73209 2.10338 1.16742 -2.23752 -3057 6 47.025 23.1272 13.2603 -26.8307 -11.5375 0.419605 -3058 4 47.6563 23.6094 12.7175 1.22463 1.60122 -3.88323 -3059 4 46.2701 22.846 12.6737 25.4538 5.98786 18.4886 -3060 6 34.5769 28.3999 10.6617 -26.3731 9.09486 -11.6064 -3061 4 34.5145 27.7223 11.3448 13.7244 -2.44185 1.37306 -3062 4 35.5023 28.5375 10.4336 6.33869 -4.76798 1.2135 -3063 6 3.33738 17.579 14.2816 -4.12164 13.1786 -2.02309 -3064 4 3.51487 16.7052 14.5979 -0.480238 -24.8864 6.17379 -3065 4 3.96197 18.0965 14.8055 -3.35437 6.17503 -1.46632 -3066 6 27.7248 11.5976 7.52038 4.0705 34.1711 4.34085 -3067 4 27.7194 12.5939 7.6487 2.26317 -33.1326 -4.66749 -3068 4 27.2616 11.2314 8.28138 -1.22149 -2.70865 2.4378 -3069 6 41.4317 28.339 9.02961 12.1835 18.6619 -21.5911 -3070 4 40.932 28.9387 9.57928 -8.65956 3.59764 13.3257 -3071 4 41.6711 28.9179 8.26221 -0.754142 -18.9314 12.3863 -3072 6 42.0732 4.78493 8.18399 0.592074 10.501 -23.0953 -3073 4 42.2656 5.73441 7.90258 -4.03181 -32.5079 3.94615 -3074 4 41.9391 4.19656 7.39311 5.50228 24.8072 19.85 -3075 6 28.4553 8.6408 40.3288 -1.1592 2.81238 -0.593175 -3076 4 27.8014 8.47839 41.05 3.29603 2.13238 -25.5829 -3077 4 28.0374 8.68456 39.4248 -2.58083 -3.24862 30.0681 -3078 6 0.723272 18.248 15.2854 4.61761 3.31073 11.0333 -3079 4 1.58056 18.1517 14.8782 17.0637 -0.561901 -5.4503 -3080 4 0.169553 17.7112 14.727 -13.9143 -7.94922 -7.42873 -3081 6 7.11829 16.2161 40.455 0.573222 -5.60735 -16.9123 -3082 4 7.21814 15.2583 40.7035 1.10072 25.2259 14.7352 -3083 4 7.17549 16.8833 41.1741 1.82325 -21.1089 2.38217 -3084 6 41.0856 8.6232 20.9154 1.44565 10.3804 -0.748136 -3085 4 40.3857 8.53297 20.2693 -12.0873 -13.8416 -3.91841 -3086 4 41.3541 9.53003 20.731 8.87844 6.62655 8.68036 -3087 6 31.7065 7.41805 37.5384 1.8504 0.880847 10.656 -3088 4 31.4927 7.12037 36.644 -5.569 -4.06437 0.235955 -3089 4 30.9766 7.14703 38.1182 6.88034 1.43502 -8.9471 -3090 6 40.7175 11.6353 25.4105 -5.83472 20.1078 -6.29096 -3091 4 40.8441 12.5768 25.6218 -9.59803 -8.51017 -7.38463 -3092 4 41.5254 11.2592 25.7328 13.3582 -17.7026 5.353 -3093 6 29.8893 30.1615 6.66958 6.45784 -4.04896 -4.41327 -3094 4 30.5285 30.6751 6.15191 0.92206 -5.81994 -1.29615 -3095 4 30.2313 29.249 6.64761 -0.535397 8.70224 -1.24193 -3096 6 40.83 24.591 5.67679 17.1105 23.9162 -4.99229 -3097 4 41.4401 25.3556 5.89599 -18.0089 -21.1831 -4.73113 -3098 4 40.1352 24.5742 6.32932 -4.29697 2.2625 8.62223 -3099 6 34.3954 9.09122 20.4203 -0.702674 2.95809 7.47625 -3100 4 33.5897 9.50113 20.7506 -0.63314 5.38769 7.97821 -3101 4 34.107 8.76785 19.5728 -0.194313 -9.82044 -16.4611 -3102 6 18.2164 33.5433 26.5438 32.3972 -29.6611 -30.5808 -3103 4 19.1929 33.4142 26.4527 -23.3283 -2.37285 -6.48837 -3104 4 18.1915 34.0681 27.3044 -13.0981 29.1765 42.7321 -3105 6 28.9207 17.4075 26.7926 -1.66434 -4.11711 9.90999 -3106 4 28.2497 17.0259 26.21 0.151798 0.605301 -3.15085 -3107 4 28.4243 17.7127 27.5796 8.50802 -3.38176 -8.48604 -3108 6 50.4389 35.5612 18.195 -0.220837 -24.3132 -9.08897 -3109 4 50.4331 35.2145 17.2813 -0.853004 14.3463 8.17747 -3110 4 50.3692 34.7248 18.6968 -4.07606 17.1918 3.62275 -3111 6 2.99582 21.5586 31.4575 0.708202 -18.646 -28.6731 -3112 4 3.24926 22.2892 30.8424 -5.67023 -11.8068 12.1364 -3113 4 2.8516 20.7624 30.8616 4.12476 24.3831 20.6408 -3114 6 36.1857 18.7483 8.60511 9.96184 26.1081 -2.68835 -3115 4 36.1356 17.8778 8.93402 3.95956 -36.7917 21.724 -3116 4 35.6171 18.7388 7.85438 -14.2398 9.24248 -24.4438 -3117 6 20.2742 6.47995 33.7286 -0.427153 4.78104 -4.08195 -3118 4 19.8935 6.35632 34.6244 -2.14212 -11.6635 -12.611 -3119 4 20.0876 5.70362 33.1559 -1.45185 1.76636 16.8362 -3120 6 13.9952 30.5211 6.65468 -0.834568 0.374695 7.89925 -3121 4 14.6781 31.0539 7.1149 -10.4447 -7.07426 -7.17019 -3122 4 13.1432 30.7212 7.07951 7.79461 1.02333 -2.73826 -3123 6 36.2732 16.4484 35.7639 18.345 14.0335 0.961522 -3124 4 37.2268 16.2475 35.9495 -24.6333 8.21497 -3.5549 -3125 4 36.1837 17.4253 35.5797 7.74798 -29.1845 4.36862 -3126 6 45.8208 37.6575 9.69399 14.3507 -31.8621 -27.6249 -3127 4 45.4608 38.3019 10.268 -8.06385 16.394 26.7739 -3128 4 46.3975 37.0305 10.1733 -1.81999 10.6315 0.898341 -3129 6 47.4165 17.984 27.6369 4.10759 -46.3966 -5.45297 -3130 4 47.5682 17.4629 26.7823 -7.01073 17.4072 30.8444 -3131 4 47.4562 17.3293 28.4007 0.542452 20.9274 -25.5144 -3132 6 25.9608 18.2932 0.952258 -4.39486 21.5955 18.9376 -3133 4 26.1989 18.9101 1.66086 12.5057 -8.35286 -7.15646 -3134 4 25.0082 18.3237 1.04468 -12.1408 -13.2893 -13.6751 -3135 6 27.3648 22.4066 4.28268 2.26175 -24.9034 0.419816 -3136 4 27.3706 23.3409 4.46802 1.80952 16.8807 -5.51915 -3137 4 27.3027 22.2785 3.32806 -2.77408 5.10873 4.5687 -3138 6 3.39125 3.84856 27.607 3.69966 -10.1033 0.490887 -3139 4 4.0137 4.55908 27.5406 6.78149 24.6072 0.911673 -3140 4 3.97847 3.09168 27.5281 -8.4044 -12.3732 0.103181 -3141 6 45.3633 27.6554 28.8452 2.12727 -1.25659 10.7713 -3142 4 44.5282 27.2015 28.6866 -4.83999 -4.58212 3.48715 -3143 4 45.3811 28.2979 28.14 4.63148 6.41932 -6.37453 -3144 6 28.4005 32.3772 16.2203 23.7034 -3.75626 0.763822 -3145 4 29.2297 32.2225 15.6968 -18.0553 4.16843 14.9752 -3146 4 28.6795 32.6874 17.1033 -0.325788 -1.29005 -11.6373 -3147 6 9.90477 33.835 13.0292 3.70295 -3.7397 30.9684 -3148 4 9.58558 33.3049 13.7992 6.56164 12.5415 -12.6178 -3149 4 9.32425 33.6546 12.2978 -12.2649 -3.83445 -16.8068 -3150 6 38.3301 26.6316 14.917 8.16845 -9.374 -1.40965 -3151 4 38.7482 25.7736 15.154 -10.3234 14.7528 -2.05039 -3152 4 37.3847 26.6122 15.1206 3.66029 -5.29 2.35016 -3153 6 31.3553 16.3729 4.24558 -11.5598 -13.3523 13.2112 -3154 4 30.5395 15.8971 4.54084 13.4071 7.11555 -7.19651 -3155 4 31.205 16.607 3.32285 -2.62497 2.93757 -4.30077 -3156 6 6.17611 3.41063 6.5613 17.7272 3.64487 37.5473 -3157 4 6.46982 3.08663 7.46094 -9.0795 17.2981 -27.883 -3158 4 6.02642 2.6045 6.08389 -2.81663 -13.5692 -12.3872 -3159 6 42.5919 12.9938 5.62253 0.302259 -11.3067 -0.460125 -3160 4 42.3001 13.8766 5.84478 4.87778 6.39543 1.2284 -3161 4 43.5084 12.9049 5.92305 -2.35353 0.46184 -1.33783 -3162 6 41.0467 31.3953 33.7949 3.79599 37.3117 5.16998 -3163 4 40.7289 31.3961 34.7173 5.05156 -5.30154 -15.2916 -3164 4 41.2174 32.3636 33.5809 -4.47671 -37.1445 4.47908 -3165 6 52.8595 12.0576 26.2617 4.7779 -12.5882 -49.4794 -3166 4 52.3971 12.713 26.7564 -13.8804 18.303 15.9364 -3167 4 52.6839 12.2865 25.2977 8.87889 -9.64762 29.5111 -3168 6 39.2197 4.29237 29.0569 11.235 6.95972 3.08537 -3169 4 38.4782 4.84799 29.3396 4.36118 -6.50894 -4.0878 -3170 4 39.9967 4.59393 29.5615 -4.77927 -7.36273 -4.89832 -3171 6 3.64414 27.0065 11.2815 -12.9441 10.9516 -6.43872 -3172 4 4.59106 26.8908 11.2849 14.3058 -9.72403 4.26042 -3173 4 3.53535 27.8319 10.7781 -8.82957 -2.80904 -0.131447 -3174 6 41.5421 29.6442 25.2671 -5.6293 3.19366 2.66863 -3175 4 41.8684 29.6903 24.3723 12.1179 -3.11764 -10.4285 -3176 4 40.7194 30.1326 25.2057 -6.30215 2.63585 1.74894 -3177 6 50.468 27.487 30.6705 -3.05594 -10.4468 2.57161 -3178 4 50.076 27.1594 31.5009 0.806547 4.01213 -5.24181 -3179 4 49.8217 28.0451 30.2184 -2.62753 1.96724 1.87939 -3180 6 32.7902 33.6258 41.7496 -4.87138 -4.97834 -25.0012 -3181 4 33.1641 32.7497 41.8541 3.47816 -11.5824 1.65798 -3182 4 32.8969 34.0586 0.665858 3.16614 12.7166 21.4132 -3183 6 5.9796 9.64598 7.93234 5.57207 13.1841 -10.7861 -3184 4 5.80592 9.95912 8.82583 -0.986272 -0.521215 4.5825 -3185 4 6.43021 10.3852 7.47125 -1.05258 -10.6241 3.31462 -3186 6 52.774 25.3768 27.6816 12.7732 -3.18466 28.0173 -3187 4 52.93 26.2779 28.0237 -8.60677 -10.695 -13.1321 -3188 4 53.2011 24.8527 28.4031 -8.37753 -2.27765 -26.5487 -3189 6 18.6947 23.2095 14.4724 -28.0966 8.43578 15.8218 -3190 4 18.5587 24.1605 14.7523 20.6562 -24.296 -13.1918 -3191 4 19.5669 23.0215 14.1303 11.4888 10.4676 -1.8787 -3192 6 31.2862 9.0706 13.0896 18.8649 -43.5027 -8.26415 -3193 4 31.2854 8.18164 13.5153 -0.98006 14.2242 -7.24428 -3194 4 30.8139 9.64196 13.6614 -21.2648 23.3567 24.384 -3195 6 52.8349 16.8368 29.9626 -1.04236 -5.83632 -3.7224 -3196 4 53.1314 16.3317 29.1809 4.11254 10.2245 6.81583 -3197 4 53.5336 17.4658 30.2088 5.59995 -2.32318 -6.64835 -3198 6 13.48 30.6403 11.9185 -26.7 12.8254 18.6299 -3199 4 12.8874 31.2649 12.4086 6.11749 -21.3055 -11.69 -3200 4 14.2712 31.1662 11.9231 18.3999 3.72963 -5.07782 -3201 6 24.4118 24.6653 11.1776 -11.0488 -38.9105 0.0232616 -3202 4 25.2327 25.0345 11.4834 15.6111 8.28781 8.86477 -3203 4 24.5324 23.6736 11.237 -9.01076 27.817 -2.51724 -3204 6 11.1207 26.7925 5.93063 -6.41259 2.09364 -8.23675 -3205 4 11.5241 26.98 6.79711 -3.12879 8.72791 -6.17468 -3206 4 10.8719 27.6544 5.50988 6.7003 -18.2386 15.7162 -3207 6 12.0069 32.3194 4.56559 -6.93674 1.89769 -53.2748 -3208 4 11.7104 31.8608 3.68045 16.1117 25.2499 46.2442 -3209 4 12.3686 33.2222 4.3326 -9.20365 -26.1492 2.14142 -3210 6 6.43611 5.48582 30.4705 10.9412 7.27018 -5.81208 -3211 4 6.8324 6.31983 30.1884 15.302 -0.761667 0.276275 -3212 4 5.5204 5.70213 30.4126 -22.6187 -2.98333 3.5448 -3213 6 38.1723 39.6045 29.3805 -11.1368 -0.968084 -7.99101 -3214 4 37.5332 40.3179 29.1036 12.1085 -24.1545 -0.917311 -3215 4 37.9804 38.7063 28.9788 -2.28765 36.4506 5.30967 -3216 6 52.5924 19.3736 5.41149 4.12965 0.0949992 -5.17576 -3217 4 52.3027 20.2712 5.07121 22.7239 -28.0308 -2.84369 -3218 4 53.4989 19.0543 5.10701 -28.7609 25.7225 2.66162 -3219 6 18.3561 9.81057 21.0683 -18.476 -24.6523 15.6829 -3220 4 17.6378 9.45854 20.4828 20.1245 14.4878 5.80252 -3221 4 19.033 10.2869 20.5982 6.82627 10.6552 -20.9713 -3222 6 14.5094 41.1238 15.0395 5.73538 -4.06503 -13.1796 -3223 4 15.2839 41.068 15.6075 4.55031 0.900939 7.74817 -3224 4 13.875 41.6599 15.5263 0.0235554 2.15182 4.98288 -3225 6 36.0027 23.903 26.7597 7.48895 21.6763 -35.676 -3226 4 35.8975 23.6043 27.6465 2.36908 -17.7227 17.2904 -3227 4 36.3267 23.2124 26.1374 -7.97178 4.49324 27.7844 -3228 6 35.6359 10.4157 26.2529 -13.2839 -25.1837 23.1485 -3229 4 35.969 10.5098 25.3716 5.3977 0.436992 -21.1808 -3230 4 35.4229 9.45302 26.3798 5.18698 20.1527 -7.56493 -3231 6 45.3037 24.2791 20.2723 9.06075 11.2998 -13.4968 -3232 4 45.4523 24.978 19.6109 10.2075 -1.49386 4.95329 -3233 4 44.5125 23.8555 19.9662 -13.3892 -9.58217 -2.04663 -3234 6 15.8107 39.0453 24.2393 9.7405 19.086 8.48056 -3235 4 15.3407 39.8143 24.6455 3.07287 -17.6695 -6.90152 -3236 4 16.7434 39.3626 24.1878 -22.1708 -8.11019 0.25747 -3237 6 4.61074 25.9041 16.8066 4.47487 12.325 4.32837 -3238 4 5.33363 26.3313 17.2996 -1.16871 -8.95741 -3.63592 -3239 4 3.89121 26.5439 16.91 5.27726 -3.71411 -3.28281 -3240 6 33.4791 9.99232 32.5716 -36.5508 -4.76722 -31.2046 -3241 4 34.3147 10.2419 32.89 39.2476 10.968 21.6954 -3242 4 33.0188 9.57531 33.3002 0.324125 -5.12222 10.2577 -3243 6 22.9388 37.5185 1.51191 -4.27166 -24.2064 8.31852 -3244 4 23.0334 38.2273 2.154 1.20614 3.86272 6.71724 -3245 4 22.69 36.6978 2.02191 6.96614 23.4315 -10.5782 -3246 6 39.1324 20.5485 25.4772 25.265 -11.778 19.9951 -3247 4 39.2103 21.4279 25.1215 -1.526 12.0473 -3.88318 -3248 4 39.8813 20.4818 26.1301 -17.748 -0.0581828 -14.4699 -3249 6 25.0622 25.0762 37.6014 21.4558 5.76047 -13.7935 -3250 4 26.0349 25.2337 37.6294 -19.4467 -8.38624 -4.14531 -3251 4 24.8891 24.8197 38.5048 -7.65564 -1.94532 12.2316 -3252 6 12.209 35.7591 11.4203 -9.12536 1.25056 -5.53999 -3253 4 11.4995 36.2015 10.8899 19.2305 -11.6187 8.3526 -3254 4 12.8486 35.4161 10.7797 -5.71729 7.89629 -2.43108 -3255 6 42.046 15.7235 20.1276 29.9467 5.46844 -26.2367 -3256 4 42.5818 15.5034 19.3148 -14.0105 1.75231 17.5608 -3257 4 42.3615 16.6209 20.337 -4.0808 -2.27778 2.90042 -3258 6 53.2021 25.4307 39.5282 4.69599 -13.2561 7.07883 -3259 4 53.78 25.8541 38.905 5.49131 5.5629 -6.42231 -3260 4 52.4802 26.028 39.6966 -10.1139 9.50655 0.821399 -3261 6 53.7967 21.778 1.29815 15.5744 -8.20383 1.43914 -3262 4 54.6378 21.4326 0.944441 -3.84265 -1.46767 8.18122 -3263 4 53.3536 22.1543 0.542634 -13.037 9.31425 -11.6048 -3264 6 1.93111 22.4438 20.1768 4.00387 4.12813 31.1185 -3265 4 1.5939 23.2361 20.6593 2.49828 -13.4199 -15.2591 -3266 4 2.41139 21.9607 20.8911 -6.34657 6.89732 -14.8434 -3267 6 41.1871 16.1847 11.4932 0.836017 42.0531 1.99799 -3268 4 40.9413 15.3195 11.802 -9.8633 -17.6073 7.87469 -3269 4 40.5377 16.8617 11.8588 16.4331 -27.7799 -8.96912 -3270 6 17.194 38.6096 9.61825 4.75854 -2.20459 -16.4638 -3271 4 17.8324 38.6167 10.328 10.0816 -0.610832 12.429 -3272 4 16.3385 38.6013 10.0398 -14.9506 0.593169 11.9887 -3273 6 33.2005 12.9606 38.531 8.50507 10.8774 -15.8661 -3274 4 33.6532 13.8203 38.39 -7.98235 -13.7359 5.26797 -3275 4 33.1331 12.8007 39.479 5.11874 5.24255 -4.23095 -3276 6 24.7171 21.675 39.9778 2.8762 -23.2501 -10.2076 -3277 4 24.5558 21.597 39.0096 0.45736 0.189324 11.8412 -3278 4 25.3262 20.9394 40.2143 -5.83632 9.86919 -3.30671 -3279 6 13.5803 15.5602 27.3532 26.1047 30.3564 11.1382 -3280 4 13.1676 16.145 28.014 -3.26959 -8.19558 -5.9347 -3281 4 12.973 14.8589 27.1951 -20.4184 -17.1677 1.43072 -3282 6 24.68 18.7128 9.26691 14.3839 36.3501 26.0009 -3283 4 25.3598 19.2552 8.82532 -5.31062 -15.6251 -9.27674 -3284 4 24.5166 19.2286 10.0937 -4.12977 -20.8661 -14.1648 -3285 6 10.971 8.2031 0.0820528 -5.05885 27.6393 52.7366 -3286 4 10.426 8.82187 0.676738 20.6953 -23.692 -21.2054 -3287 4 11.8511 8.19112 0.51746 -10.8092 -0.715691 -8.01276 -3288 6 15.7168 31.9426 31.3882 -16.0589 -14.8784 11.374 -3289 4 14.8784 32.0139 30.9212 -5.19427 4.39929 -5.1125 -3290 4 16.2361 32.7208 31.1626 4.51908 -4.85975 -1.07492 -3291 6 20.3853 39.1678 21.6201 3.96912 1.70678 -2.15463 -3292 4 19.8408 38.4031 21.9136 18.3946 15.2484 5.21077 -3293 4 21.1259 39.3411 22.2478 -18.5683 -14.4588 -3.61544 -3294 6 38.8575 19.5345 7.60357 -3.22682 7.2187 -10.7103 -3295 4 37.9955 19.1157 7.58645 -3.56529 1.50397 -1.646 -3296 4 39.2183 19.2349 8.43232 7.58358 -7.76078 7.45775 -3297 6 41.3566 29.7161 21.1634 -18.4754 -13.1658 17.2704 -3298 4 41.7904 29.7702 20.3348 3.95998 3.00501 -30.3792 -3299 4 42.0386 30.0045 21.7486 9.4821 7.67994 22.7786 -3300 6 50.7055 33.8359 22.0677 10.0235 -14.5617 12.8511 -3301 4 51.0634 32.983 22.4061 -4.7136 19.0099 -8.42991 -3302 4 50.4062 33.6539 21.1646 0.0172424 0.211956 1.78818 -3303 6 18.1576 11.1602 14.3564 -14.1594 -3.53412 4.86119 -3304 4 18.0624 11.3441 15.3149 3.69196 -2.83217 -14.991 -3305 4 19.1071 11.0831 14.1997 2.21718 -0.861887 0.62752 -3306 6 48.509 14.2737 15.2536 -33.8512 -15.7039 -13.3543 -3307 4 49.4102 14.4821 15.4142 31.3042 4.03673 3.1002 -3308 4 48.4635 13.5769 14.5611 0.497508 10.2707 10.4073 -3309 6 32.9892 15.7452 8.24788 15.5762 1.59093 3.47394 -3310 4 33.8184 15.532 7.78513 -5.99942 0.288096 4.45585 -3311 4 33.1922 15.7362 9.20789 -3.05234 -0.622843 -13.6288 -3312 6 42.9176 4.85532 18.7629 14.1748 1.41964 3.40057 -3313 4 42.9882 5.82921 18.9229 4.77982 -22.1758 1.39114 -3314 4 43.8043 4.45344 18.9624 -18.3785 17.0247 -7.93082 -3315 6 10.5031 23.7237 33.4382 -0.874073 19.9298 2.74355 -3316 4 10.5548 24.717 33.3795 7.7257 -28.8706 -7.54496 -3317 4 11.1379 23.281 32.8547 0.735263 11.3428 1.89897 -3318 6 1.13216 20.0583 11.2836 18.374 17.5884 12.1148 -3319 4 0.491024 19.3349 11.1994 -2.17247 3.20995 10.4498 -3320 4 1.13554 20.5377 12.169 -13.4236 -25.5013 -29.3002 -3321 6 1.52072 39.5358 14.3069 -1.86369 -19.4721 11.7014 -3322 4 0.846705 40.1803 14.5938 4.14733 -5.95668 -5.60613 -3323 4 1.29368 38.6598 14.724 6.32152 28.9753 -9.07681 -3324 6 8.31775 21.6111 14.1387 -15.017 -6.93379 31.3726 -3325 4 8.13664 21.1659 15.0266 4.22851 15.111 -30.7591 -3326 4 7.52757 21.5034 13.5919 -1.9589 1.09648 1.01763 -3327 6 7.16491 13.3069 38.2405 -3.91014 1.61314 -29.5843 -3328 4 6.63698 13.0539 37.4502 4.01765 -4.94514 23.7112 -3329 4 7.51249 14.1719 37.966 2.17516 -8.38294 10.659 -3330 6 46.6268 1.62726 18.6981 -5.20766 -2.9114 16.5849 -3331 4 47.5711 1.68468 18.9367 -9.38594 -0.162468 5.90612 -3332 4 46.1191 1.48652 19.5414 20.1897 3.23395 -16.531 -3333 6 4.07867 8.38347 14.797 30.0262 18.9917 2.43531 -3334 4 3.34187 8.3175 15.3794 -25.1937 -7.21885 10.0707 -3335 4 3.92422 7.81173 14.052 -7.87119 -13.0009 -15.9092 -3336 6 47.5843 36.535 17.848 27.4213 12.0237 5.93301 -3337 4 47.2301 35.69 17.6416 -25.9655 -28.1947 -7.00186 -3338 4 48.5203 36.321 17.8356 11.6458 7.4707 2.49139 -3339 6 48.7172 32.6081 3.62434 16.9155 19.6851 -27.3563 -3340 4 49.4676 32.1613 3.18145 -8.8052 -0.0369675 17.0972 -3341 4 48.3534 32.1141 4.33579 -5.12692 -24.8974 22.5299 -3342 6 26.8624 34.4063 15.194 -5.61502 8.38998 -0.355377 -3343 4 27.128 33.6719 15.7603 3.91671 -4.37186 -8.54489 -3344 4 27.3784 34.3384 14.3661 -3.09932 -5.4603 13.6569 -3345 6 9.98983 27.3411 13.3236 -5.30345 -60.6937 -19.0037 -3346 4 9.94192 28.2179 13.0053 -1.51785 37.2293 -13.4128 -3347 4 9.87191 26.7487 12.5139 4.66007 24.2176 27.9858 -3348 6 2.39898 26.8872 37.357 1.59401 -7.29113 19.9813 -3349 4 2.39832 26.7504 38.3162 -5.28205 -0.510768 -0.23331 -3350 4 3.33711 26.9514 37.1904 14.8183 3.44774 -11.9786 -3351 6 33.3368 17.2756 36.8005 -23.2882 7.84328 1.94786 -3352 4 32.371 17.4043 36.8526 5.24602 0.476467 11.7287 -3353 4 33.4423 17.1515 35.8622 12.5187 -3.29866 -15.2334 -3354 6 10.6624 18.8035 9.30575 -3.98781 15.2275 -14.7508 -3355 4 10.7339 18.764 8.32616 -2.59554 -5.92059 15.2764 -3356 4 10.8972 19.732 9.49452 -1.55193 -6.4517 3.37647 -3357 6 8.57833 27.4047 3.14019 -5.09403 -6.13324 -2.85576 -3358 4 8.57126 27.6547 4.08504 -2.7611 -8.03155 -6.83353 -3359 4 8.4622 26.4231 3.09919 3.19624 23.0742 12.9307 -3360 6 40.6073 33.9264 14.3399 -6.85038 20.2562 -23.9123 -3361 4 40.863 33.245 14.948 0.807967 -8.16399 15.1571 -3362 4 40.0779 34.5716 14.8204 -0.495244 -4.69725 4.10141 -3363 6 53.9925 16.7992 13.6308 6.31935 -7.9338 28.1888 -3364 4 54.0997 17.1551 12.7528 -11.031 14.1585 -18.9596 -3365 4 53.1709 17.0486 14.0912 -3.14305 7.59696 -13.573 -3366 6 39.1497 38.4912 7.40608 -39.1223 4.05884 30.5073 -3367 4 38.8859 38.5922 6.48797 -2.00378 4.08479 -3.77896 -3368 4 38.3062 38.5986 7.97667 35.5804 -2.74434 -28.8566 -3369 6 42.2129 33.6808 29.0138 -24.1371 3.42921 -11.8129 -3370 4 42.1057 34.6378 28.7577 -2.98627 -25.8941 0.854821 -3371 4 41.3475 33.1819 28.8496 28.8118 27.0492 8.45917 -3372 6 2.85866 0.0629173 20.1315 -20.2536 1.52979 -19.4947 -3373 4 2.75203 0.421025 19.2221 8.85994 -2.20895 9.93397 -3374 4 1.96017 41.6124 20.299 15.6791 2.4666 6.01858 -3375 6 24.986 26.9373 24.4454 -5.13687 18.0728 7.96565 -3376 4 25.2851 26.0172 24.3926 4.88984 -3.86206 4.04103 -3377 4 25.2923 27.4081 25.2509 0.579281 -17.4573 -11.648 -3378 6 13.6179 33.9875 7.01366 -9.87556 12.4155 -39.0476 -3379 4 14.4287 33.6264 6.65472 5.99816 -4.92128 6.68342 -3380 4 13.2096 34.3429 6.17379 4.4552 -5.00021 31.0775 -3381 6 17.6494 31.8378 3.38868 3.47258 32.8259 -24.0658 -3382 4 17.3179 32.0585 2.49435 6.00696 -1.44586 18.975 -3383 4 17.3532 30.9566 3.5196 -11.0767 -31.773 11.9025 -3384 6 31.1111 29.8483 35.9167 13.6376 7.61418 -14.6842 -3385 4 30.4141 29.611 36.5018 -19.519 -6.65958 16.6428 -3386 4 31.8988 29.4329 36.2727 4.98993 0.410401 2.8928 -3387 6 31.4643 1.69164 1.93808 20.5111 47.6543 28.2436 -3388 4 30.8038 1.05919 1.86135 -35.916 -50.7273 -13.0106 -3389 4 30.9957 2.32106 2.5233 13.9145 -2.66096 -10.7861 -3390 6 13.7147 9.36591 12.3063 -10.8769 -31.3803 3.40225 -3391 4 14.006 10.2311 12.0687 5.19854 25.7457 4.3425 -3392 4 13.2135 9.34561 13.1466 7.78847 9.513 -6.56361 -3393 6 15.2882 15.1512 12.1315 -28.7349 -8.10496 1.75886 -3394 4 14.285 15.1274 12.2085 32.3197 -4.02875 -3.81405 -3395 4 15.5527 14.5676 11.4001 -6.69875 1.91641 1.76342 -3396 6 44.9132 30.4441 13.088 -39.1187 -0.31911 18.6923 -3397 4 45.3561 30.6438 13.8967 -2.95974 2.37903 28.1101 -3398 4 45.6316 30.4633 12.5179 38.3165 -3.24606 -51.9295 -3399 6 35.1465 37.623 24.8576 -14.1582 -15.7359 28.7413 -3400 4 34.5779 38.3725 25.1706 10.6028 -16.3472 -5.82963 -3401 4 34.9593 36.856 25.4995 5.71155 29.9045 -22.7235 -3402 6 43.8948 19.2936 12.9987 -2.30513 -18.2146 13.0469 -3403 4 43.787 18.3102 12.9069 2.76315 21.1578 4.09431 -3404 4 44.375 19.4187 13.8444 -6.58761 -4.34429 -6.9628 -3405 6 14.1971 27.3925 16.8971 2.69526 11.3314 -20.1154 -3406 4 13.4533 26.7979 16.9981 -2.42546 -10.6182 5.16389 -3407 4 14.0783 27.734 15.9851 5.1255 -3.8968 13.4589 -3408 6 5.08574 37.4729 15.7377 1.34169 3.72011 38.8669 -3409 4 5.88395 37.4897 16.2981 -4.65405 2.63162 7.63907 -3410 4 5.46406 37.2335 14.9215 11.9791 -13.9554 -41.5179 -3411 6 35.4862 36.9766 33.2333 -36.83 -5.70901 2.9599 -3412 4 36.4114 37.1444 33.1615 28.5824 10.2327 4.96708 -3413 4 35.1164 37.4942 33.9725 5.15458 -1.79752 -2.84758 -3414 6 6.636 31.7097 32.9848 -22.7133 -7.33235 -24.9389 -3415 4 7.22761 30.9741 32.8206 4.14198 -5.34147 5.16294 -3416 4 6.9999 32.2337 33.6789 14.5784 9.31919 13.8511 -3417 6 31.283 20.2175 25.4647 -9.91499 -1.61286 9.73388 -3418 4 30.5344 20.24 26.1037 18.6204 0.149313 -5.83605 -3419 4 30.8734 20.4846 24.6365 -0.167457 4.09649 -2.99843 -3420 6 54.9487 26.0868 7.35258 -28.6285 -0.216784 1.76255 -3421 4 54.2955 26.5615 6.794 6.74078 -5.97369 7.99882 -3422 4 54.4034 25.6757 8.0611 9.89476 6.61779 -10.5703 -3423 6 17.8651 35.1614 24.3791 -20.7499 -4.98646 -29.5673 -3424 4 18.0576 34.6235 25.1649 -8.37985 -1.7243 -11.1178 -3425 4 17.2007 34.681 23.779 26.831 10.1018 28.2803 -3426 6 49.1285 3.31358 19.7417 -8.45795 -3.91869 -17.1851 -3427 4 48.8119 4.11203 20.1653 -3.29153 9.9905 4.05996 -3428 4 49.7807 2.96094 20.3466 4.32541 -4.85853 3.16639 -3429 6 30.2844 35.6035 13.4934 7.2001 -0.317469 -2.452 -3430 4 29.4623 35.659 12.9857 1.71884 -1.71824 2.45729 -3431 4 30.0585 35.4328 14.4204 -4.00669 1.3983 -5.34585 -3432 6 43.3887 25.8808 41.6785 -22.9069 -12.3923 -2.55701 -3433 4 43.9997 25.6768 40.9817 12.0928 0.211006 -14.0269 -3434 4 43.8339 26.4255 0.397834 14.8568 14.8319 19.2759 -3435 6 21.0884 23.1529 6.38678 -1.35916 1.28851 13.8592 -3436 4 21.4 23.8645 6.98768 -5.78702 -12.5756 -9.70729 -3437 4 21.3246 23.4545 5.51028 2.40121 5.3387 -13.5131 -3438 6 54.6143 21.1989 19.0895 1.0726 18.3039 13.0104 -3439 4 0.43531 21.5582 19.5367 -15.0683 -8.68203 -12.1911 -3440 4 53.867 21.7044 19.4937 16.3508 -9.47613 -7.9193 -3441 6 13.877 38.9443 18.7624 -3.57764 -10.5141 -5.7706 -3442 4 13.4493 38.4672 19.4981 1.6116 7.10734 -3.21136 -3443 4 14.0821 39.8514 19.0249 -5.40993 2.00969 6.25434 -3444 6 39.1872 2.73234 39.6824 0.14108 0.727177 -8.14712 -3445 4 38.529 2.27328 40.2354 4.03816 -1.16808 -5.22543 -3446 4 39.0548 2.41866 38.7627 -6.48078 -0.982324 12.2661 -3447 6 43.2185 33.8148 8.84061 -19.4182 46.8926 -2.36482 -3448 4 43.1772 32.9719 9.24022 -1.50187 -35.3898 17.2737 -3449 4 42.5163 34.3616 9.29053 19.0727 -15.0644 -10.6104 -3450 6 23.089 16.6827 12.1027 15.7208 -3.2574 -7.89972 -3451 4 23.4385 16.1911 11.3228 -11.6069 8.24456 13.4993 -3452 4 22.136 16.8018 11.9813 0.424679 -1.38664 -3.29845 -3453 6 40.7855 26.1389 36.3196 -19.9126 19.309 9.87347 -3454 4 40.0986 26.8534 36.2514 19.4153 -21.5003 1.38126 -3455 4 41.1517 26.0031 35.4437 4.25962 0.995192 -8.54639 -3456 6 15.1503 11.6717 19.2973 0.724699 -1.19191 17.6918 -3457 4 15.5299 12.2877 18.6792 5.27756 8.7759 -18.41 -3458 4 15.4868 12.0294 20.1269 -4.65024 -4.08223 3.58338 -3459 6 9.86165 29.8154 31.387 -8.94942 -10.7424 5.06077 -3460 4 10.5846 30.1184 31.9716 0.245343 7.83947 -17.0155 -3461 4 9.856 30.1645 30.4637 12.8302 0.479173 21.4055 -3462 6 2.12473 30.035 25.2763 1.78753 8.3758 2.85176 -3463 4 2.08519 29.2167 25.7943 1.54705 3.16986 -12.4779 -3464 4 2.12365 29.8679 24.3136 0.147535 -6.31004 19.3474 -3465 6 49.0081 10.6471 7.05663 3.22839 15.7191 0.010386 -3466 4 49.8069 10.5015 7.59507 -11.7369 -5.9273 -2.35907 -3467 4 48.4474 9.86293 7.09337 3.15572 -10.0552 5.75386 -3468 6 38.6524 34.4248 32.4903 14.0617 12.8107 -4.97275 -3469 4 38.3124 35.2999 32.7524 2.4491 -7.54743 -1.61947 -3470 4 38.3152 33.7696 33.1015 -5.90625 -1.07654 6.02858 -3471 6 24.2925 24.7077 4.76791 -9.60212 12.423 13.627 -3472 4 24.6592 23.9059 5.14091 6.4374 -12.2494 -4.05598 -3473 4 24.0877 25.2629 5.55261 2.76703 -5.61196 -18.2913 -3474 6 44.0394 23.5955 33.7722 -22.1761 -10.7316 25.8053 -3475 4 43.54 23.0408 33.1405 14.8275 10.6039 0.934173 -3476 4 44.7909 24.0173 33.3845 18.136 8.68259 -21.6513 -3477 6 45.1404 31.9557 26.6336 7.63501 -16.8517 -19.5705 -3478 4 44.7419 32.078 27.4825 -5.98757 6.26965 19.5048 -3479 4 44.9572 31.0195 26.4087 0.928196 13.8489 4.22851 -3480 6 52.067 6.35346 22.8527 -23.4258 -19.9992 -0.226773 -3481 4 51.4359 5.65775 23.1792 22.6487 15.1416 -4.78776 -3482 4 51.473 7.11391 22.7826 5.97124 1.02094 -2.8274 -3483 6 5.11659 17.7141 30.4608 -43.6072 -14.7819 8.36724 -3484 4 5.56343 17.5578 29.6371 20.9412 3.52217 -11.7922 -3485 4 5.63141 18.2128 31.0754 22.7819 13.5036 5.79607 -3486 6 48.537 17.0137 6.52887 28.2349 12.1042 -25.3981 -3487 4 48.2628 16.1023 6.56372 -5.81913 -12.4107 2.5618 -3488 4 49.2494 17.0592 5.82246 -25.6562 2.24824 21.9849 -3489 6 13.808 31.3142 23.4689 -3.64011 -9.68131 26.3432 -3490 4 14.1349 31.2178 24.3617 -12.0329 4.75192 12.2102 -3491 4 14.6149 31.173 23.0226 30.8248 -5.26015 -34.1434 -3492 6 28.4946 33.4369 26.0285 16.4638 25.2333 -6.25798 -3493 4 28.7216 32.7387 25.4298 8.48672 -9.67688 -13.795 -3494 4 27.7897 33.0868 26.5316 -24.4903 -9.494 23.2581 -3495 6 9.0435 22.9594 11.008 21.162 0.605596 1.29652 -3496 4 9.33306 22.7779 10.1087 -4.82127 0.713158 -4.26872 -3497 4 9.8456 22.7632 11.5172 -9.5186 2.48902 2.0044 -3498 6 40.5545 4.06728 26.5809 44.6249 -53.7912 6.90123 -3499 4 40.0988 4.06982 27.4038 -17.0162 4.47424 24.8249 -3500 4 40.1579 4.71783 26.0744 -31.5116 46.4114 -32.7723 -3501 6 17.0554 37.9737 20.9489 23.2001 5.84937 -15.1211 -3502 4 17.8184 37.6206 21.4529 -18.1961 -0.773306 2.14347 -3503 4 16.241 37.9215 21.4323 -8.54619 -6.77157 16.0583 -3504 6 31.9589 6.36634 14.2007 -32.7312 -5.18635 1.31695 -3505 4 31.6173 5.45206 14.3159 2.63352 8.72785 -2.4018 -3506 4 32.9006 6.25378 14.1536 18.2531 -4.45925 -0.605861 -3507 6 29.3682 34.9487 39.6588 1.61784 2.82525 -17.5597 -3508 4 29.3689 34.7576 40.5935 -6.77547 -0.101859 12.4897 -3509 4 28.4273 35.0463 39.4168 8.43037 -3.37269 4.33216 -3510 6 22.5699 2.93494 32.1141 -1.63629 -8.86743 4.25418 -3511 4 23.0898 3.67063 31.7669 1.49018 1.71101 -1.29845 -3512 4 22.818 2.15292 31.5827 -1.92581 11.5593 5.09528 -3513 6 51.7444 19.0899 24.8018 18.5566 14.3159 27.8709 -3514 4 52.1262 19.3991 25.6728 -16.855 -8.06891 -29.5747 -3515 4 52.1578 19.634 24.1129 -3.61196 1.33098 2.20453 -3516 6 32.1137 13.664 24.2226 6.2567 1.72658 -37.8727 -3517 4 32.2307 13.7857 25.1378 6.97488 6.10606 45.7276 -3518 4 31.1794 13.5551 24.0935 -22.8325 -3.39176 -1.92521 -3519 6 9.48788 30.1788 28.8037 -7.90151 -0.480281 -10.0021 -3520 4 9.04214 29.3907 28.4657 0.296662 -4.58444 4.12418 -3521 4 9.71381 30.648 27.9899 1.85323 2.91474 4.33114 -3522 6 31.3027 3.12343 24.087 3.70677 4.08208 -3.18372 -3523 4 30.8363 3.94541 23.9161 -7.21645 -1.79011 2.75115 -3524 4 32.1629 3.26377 23.6687 3.35255 -5.74571 3.4439 -3525 6 2.14326 19.8385 36.4613 43.5578 -10.0216 -16.9659 -3526 4 3.05142 19.7594 36.0352 -31.8637 8.98539 19.2185 -3527 4 1.69253 19.0555 36.1346 -14.6763 0.545221 1.96285 -3528 6 36.957 16.7591 14.0918 2.96563 -13.2358 -6.51153 -3529 4 37.0513 17.1687 14.9682 1.23982 -3.45998 -2.6752 -3530 4 37.3406 15.8552 14.1067 -4.20166 12.9403 2.86695 -3531 6 1.82327 11.1921 6.0808 -0.275886 9.47834 -4.04825 -3532 4 1.66503 10.3513 6.51275 0.636708 -7.94921 -0.277572 -3533 4 1.41092 11.8149 6.68093 -3.53423 6.76721 2.7814 -3534 6 43.1526 36.8455 25.2619 -8.14588 -11.3328 3.19442 -3535 4 42.3648 36.774 24.6888 4.17675 -0.750929 11.0286 -3536 4 43.0263 36.2034 25.9927 3.18182 11.8936 -13.2388 -3537 6 32.1279 5.54767 7.01242 2.49094 2.37791 -5.83138 -3538 4 31.9279 4.68363 7.38152 0.218816 -4.41428 4.71371 -3539 4 31.563 6.18782 7.45455 -6.02642 2.24751 5.27561 -3540 6 15.066 21.4965 41.5173 26.6113 -14.2353 0.879596 -3541 4 14.4098 21.4318 0.299313 -13.8163 5.2854 1.00244 -3542 4 14.7314 21.9782 40.7628 -14.3918 6.6959 -6.38566 -3543 6 37.0263 36.0654 5.67599 -8.66989 11.0394 5.08886 -3544 4 36.7926 36.9074 5.26668 1.42879 3.21556 -9.50708 -3545 4 36.6993 36.1724 6.58455 6.67811 -8.44617 -2.15326 -3546 6 39.6264 22.8802 0.345968 -6.61229 0.0560669 1.87747 -3547 4 39.9979 23.7083 41.9266 1.97423 1.58642 1.0556 -3548 4 39.8106 22.8717 1.30105 -0.716498 -2.72173 1.5866 -3549 6 18.4762 23.1875 5.24196 -3.43754 -16.0644 -0.1002 -3550 4 18.2109 24.0785 4.97873 9.26343 12.8459 2.1419 -3551 4 19.3202 23.1705 5.73113 -5.23082 11.7415 -3.58503 -3552 6 34.4866 26.3931 0.410981 -26.1443 -19.9516 50.1306 -3553 4 33.9706 27.0567 0.94736 13.8106 -10.3269 -20.7381 -3554 4 34.4077 25.5868 1.01915 10.7474 25.1704 -28.4611 -3555 6 28.1474 26.0925 40.6196 -28.5345 -18.6936 36.4955 -3556 4 29.0529 26.0026 40.9247 9.18224 2.32741 -2.79367 -3557 4 27.6107 25.644 41.3519 15.6172 17.8969 -31.6189 -3558 6 41.7482 4.39863 30.2421 -5.41295 4.8086 27.4354 -3559 4 42.5847 3.93131 30.2216 8.80522 -6.59194 -7.61494 -3560 4 41.6924 4.68152 31.1831 -5.94926 -0.146025 -12.4776 -3561 6 4.45598 8.30655 29.1222 20.5127 -16.5965 8.52389 -3562 4 3.66946 8.7156 28.7677 -9.60933 13.4518 -0.978151 -3563 4 4.96147 8.97819 29.6123 -10.8114 0.933443 -7.64816 -3564 6 12.9096 9.61234 32.1411 7.95239 -11.3181 7.67023 -3565 4 12.5174 8.82681 31.7782 -9.40951 -4.97415 -8.25208 -3566 4 13.381 9.26623 32.9076 3.83436 11.6436 3.42456 -3567 6 48.6608 16.2478 1.44826 -41.5847 5.12436 -2.24268 -3568 4 49.5977 16.2655 1.51923 27.6715 2.95254 13.2549 -3569 4 48.2356 16.5221 2.2956 18.9339 -8.30142 -14.6437 -3570 6 26.4307 40.0076 21.1903 -9.81311 41.2665 6.04236 -3571 4 27.1749 40.6498 21.1967 -8.04845 -12.0635 0.822588 -3572 4 26.7755 39.1508 21.0026 13.0624 -20.4442 -2.17563 -3573 6 35.79 4.08177 9.00682 -31.6066 0.334495 -4.41207 -3574 4 35.483 4.74976 8.36033 1.0784 -4.66377 5.72074 -3575 4 35.0087 3.86601 9.59196 22.2264 5.21899 -16.6494 -3576 6 52.6895 3.55332 27.8634 16.2443 -8.90238 -17.7273 -3577 4 53.4861 3.5089 28.4695 -19.2533 -5.0216 -23.8454 -3578 4 52.9436 3.34738 26.8904 -3.28408 11.0051 45.9059 -3579 6 48.3169 26.6974 27.3926 25.9077 -23.6746 5.28014 -3580 4 49.0048 25.9927 27.5456 -25.7263 19.495 -6.18754 -3581 4 48.6886 27.4598 27.8411 -2.12981 11.4596 4.51315 -3582 6 24.5097 4.95686 18.7286 -11.1396 -9.34012 13.2359 -3583 4 24.0942 4.18073 19.1756 8.31772 16.1923 -9.35863 -3584 4 23.9484 5.73893 18.8892 6.66511 -10.1227 -0.689949 -3585 6 24.0567 12.4804 28.7686 -1.83015 0.889486 -1.95598 -3586 4 23.1997 12.8888 28.9043 -2.54864 9.49841 4.61676 -3587 4 23.8244 11.6446 28.3683 7.90245 -6.62953 -5.67748 -3588 6 40.1561 27.7426 40.8073 -21.5317 7.14576 -7.35733 -3589 4 40.4932 26.962 41.2601 -12.917 0.0491148 -0.726507 -3590 4 39.1936 27.5721 40.6401 25.9681 1.33069 1.19471 -3591 6 11.9274 13.5458 26.9496 -4.40765 -1.96337 -6.60028 -3592 4 10.9986 13.6678 27.167 -4.51497 -1.32563 0.190923 -3593 4 12.2404 12.8654 27.5442 6.31176 -11.0874 3.59056 -3594 6 52.1902 29.5387 41.394 18.594 -11.3781 3.59259 -3595 4 51.989 30.3087 0.0068425 -9.85392 15.5397 4.91192 -3596 4 53.1003 29.3208 41.6912 -5.64389 -6.04423 -8.59676 -3597 6 17.4867 19.0227 39.1838 -6.27455 21.666 2.75279 -3598 4 17.488 19.586 40.0024 0.860103 -14.9947 -21.9977 -3599 4 17.2876 19.5951 38.4014 5.36511 -12.0476 21.2649 -3600 6 46.2283 27.6807 33.7144 -6.74129 13.676 11.5468 -3601 4 46.0876 28.3582 33.0447 4.86435 -1.49715 -10.0026 -3602 4 45.6533 27.9743 34.4365 0.457797 -3.70748 6.99028 -3603 6 35.8353 29.5439 5.61992 2.49906 -1.59566 -19.7219 -3604 4 35.6527 29.5233 4.66367 4.90114 -0.621078 3.19465 -3605 4 35.4473 30.3766 5.88547 -3.82587 11.7884 10.6864 -3606 6 47.2822 25.7798 30.1513 -10.5766 8.53329 -17.9568 -3607 4 48.1664 25.813 29.7363 -13.2628 3.84456 1.19765 -3608 4 46.6616 26.387 29.6551 21.0058 -12.1546 6.47151 -3609 6 51.3953 12.3638 20.0228 -1.62023 8.46277 -4.73872 -3610 4 50.7529 12.7462 19.4094 4.65296 3.97806 -1.37635 -3611 4 50.8736 11.6867 20.4477 2.10356 -10.8225 11.04 -3612 6 41.9857 18.3757 28.9464 12.9674 -8.39178 -20.9845 -3613 4 42.6678 18.0249 28.3214 -8.5661 8.58724 12.8041 -3614 4 42.4509 18.9846 29.5329 1.95722 -2.13958 -2.01301 -3615 6 53.5955 6.47736 7.49747 -17.4879 -34.0434 -11.6994 -3616 4 53.215 5.56736 7.34717 12.2612 27.0176 1.32153 -3617 4 53.8473 6.47025 8.42428 8.27981 0.813073 3.28926 -3618 6 9.90701 10.6092 26.7593 2.25524 -7.80823 -0.160956 -3619 4 10.2937 10.2906 27.6083 -8.74192 13.2514 -11.8083 -3620 4 9.6719 11.5504 26.8324 5.3909 -8.28719 7.73453 -3621 6 9.32838 39.4044 29.7661 28.1478 19.087 17.9947 -3622 4 10.1636 39.3682 30.3277 -29.6144 2.71186 -18.0569 -3623 4 8.79772 40.1574 30.1092 9.7156 -13.1012 -9.05156 -3624 6 33.3969 4.77935 0.0338577 7.04977 -8.48101 -1.75146 -3625 4 33.7652 5.5373 41.4968 -3.54645 16.0087 -2.35532 -3626 4 34.1271 4.15493 41.8774 -6.76144 -3.49152 6.70786 -3627 6 35.7118 10.6691 34.2465 30.5451 -20.2214 -10.6481 -3628 4 35.199 10.7815 35.0349 -14.696 6.44481 20.012 -3629 4 36.4515 10.0721 34.5187 -16.7263 14.6249 -6.06398 -3630 6 15.1941 17.3851 19.1797 2.70911 -28.1342 -44 -3631 4 15.4897 16.9339 18.3047 -12.3876 19.7973 41.7399 -3632 4 14.2542 17.5546 19.0074 0.407714 2.19657 2.29796 -3633 6 17.478 37.6645 15.4329 -18.9254 1.45878 17.8737 -3634 4 16.9549 37.8023 16.2867 26.4617 -7.60783 -22.0624 -3635 4 18.4074 37.4659 15.6333 -6.79317 3.25497 7.31584 -3636 6 26.2497 8.20945 21.7084 13.406 8.66037 11.1677 -3637 4 26.4123 8.51714 22.643 -13.4745 -7.28424 -22.9055 -3638 4 25.3027 8.1176 21.5293 -5.49097 3.27453 10.4234 -3639 6 0.34 9.90937 15.4047 -28.932 15.8312 -5.67551 -3640 4 1.21626 9.57115 15.2747 8.47529 -16.8828 -5.88536 -3641 4 54.6903 9.41637 14.8207 22.8064 6.49071 10.4803 -3642 6 13.4564 40.6532 9.29599 -22.1307 -5.15585 -0.326819 -3643 4 12.4714 40.4452 9.30279 34.033 7.20134 3.90171 -3644 4 13.9359 39.9749 9.79874 -9.44555 -0.536228 -2.64909 -3645 6 49.5525 25.9167 33.0087 8.30289 -20.978 36.7812 -3646 4 50.1102 25.581 33.7998 -31.2394 16.5759 -41.6702 -3647 4 48.6381 25.5592 33.0807 18.1841 3.33668 -0.378289 -3648 6 37.0921 40.0433 26.4323 -69.9693 32.9093 31.9949 -3649 4 36.1848 39.6472 26.7001 50.2617 0.87061 -16.3943 -3650 4 36.887 40.9984 26.66 23.4133 -30.5831 -16.8038 -3651 6 47.9876 17.8592 12.1588 -8.21233 14.3088 -32.1086 -3652 4 47.5845 18.6288 11.6747 8.44083 -19.6159 16.8154 -3653 4 47.7143 17.8826 13.0665 -7.39134 3.08395 19.3289 -3654 6 27.9663 29.0642 34.1603 1.53587 -18.0299 -1.74725 -3655 4 28.882 28.804 34.3498 -7.37789 1.41773 -2.30399 -3656 4 27.9529 30.0159 34.1809 1.22694 21.8088 1.61581 -3657 6 34.0029 2.78452 13.2168 -24.1529 16.185 8.10865 -3658 4 33.6393 2.32953 13.9926 -4.91269 2.52718 -2.68734 -3659 4 34.7844 2.29731 13.0428 30.2788 -14.7346 -8.06408 -3660 6 28.44 36.053 11.4482 -19.9886 -0.916941 20.5685 -3661 4 28.0041 35.3416 10.9605 0.296796 1.69001 -2.92558 -3662 4 29.0597 36.4216 10.8465 18.9417 8.99323 -20.1084 -3663 6 36.1834 11.364 28.8528 2.80179 -1.8504 -16.6465 -3664 4 35.2026 11.3648 28.9433 17.0081 -1.44193 -10.527 -3665 4 36.4266 11.2403 27.8881 -16.5332 2.0664 24.3605 -3666 6 24.8155 39.488 16.899 1.95651 8.69094 -17.2938 -3667 4 24.2729 40.277 17.0547 2.68209 -2.76325 7.28198 -3668 4 24.7648 39.3887 15.9322 -0.898649 -0.731043 6.96785 -3669 6 49.9432 8.0514 22.8505 -60.8038 -24.1516 -13.0827 -3670 4 49.7668 7.94962 23.7845 10.2147 3.57848 16.1239 -3671 4 49.0378 7.75433 22.5026 41.2245 11.1916 1.13457 -3672 6 52.0935 19.338 10.2277 12.6357 -4.19253 18.0692 -3673 4 51.6063 19.2592 9.39778 1.74616 10.4418 -3.52762 -3674 4 52.4735 20.2434 10.294 -12.5007 -15.5081 -12.5544 -3675 6 24.8386 15.8838 6.12895 -18.3448 14.0073 -0.236232 -3676 4 24.2024 16.3229 6.74681 14.2411 -11.6767 -8.77744 -3677 4 24.4989 16.1625 5.25788 7.11766 -3.93298 6.13727 -3678 6 49.3148 23.6851 8.6303 24.9689 -39.379 16.691 -3679 4 49.2746 22.9584 9.31909 -7.63259 29.9964 -23.4819 -3680 4 48.4638 24.0489 8.3953 -15.5352 0.433996 3.53825 -3681 6 0.208059 10.6481 32.1797 22.1875 -2.28391 4.69689 -3682 4 1.08388 10.2912 32.3483 11.827 -2.86298 -20.6213 -3683 4 54.878 10.581 33.0649 -30.4469 3.74284 18.7822 -3684 6 12.5874 32.9143 13.2407 -35.4131 4.94433 4.95913 -3685 4 11.7345 33.4182 13.1185 22.1299 -14.9844 2.19911 -3686 4 13.2795 33.4792 12.9271 13.1216 10.0242 -5.44208 -3687 6 21.734 32.5657 14.1089 -30.2641 -10.609 17.8788 -3688 4 21.1735 33.3586 14.1938 13.4775 0.171544 -7.80997 -3689 4 21.2373 31.9121 14.6504 18.4585 12.3126 -12.4653 -3690 6 48.1656 34.8484 27.3207 -34.4178 -12.3509 -32.6658 -3691 4 47.5287 35.1179 27.9926 9.598 2.53078 9.45385 -3692 4 47.5616 34.4813 26.6056 29.2581 12.2879 19.461 -3693 6 45.6153 31.2627 36.0943 -37.261 16.4569 21.0579 -3694 4 45.7916 31.8927 35.3904 -0.807743 4.61331 -8.81752 -3695 4 44.8366 31.6277 36.6156 19.759 -7.25665 -17.1647 -3696 6 46.2873 0.296503 14.3622 0.346279 -8.22198 0.0964187 -3697 4 46.2502 1.23933 14.2464 -13.6881 13.1616 4.37405 -3698 4 47.2018 42.0236 14.1712 14.709 -12.2876 -2.23521 -3699 6 14.3299 18.994 40.2006 -30.7379 -32.6603 -9.06287 -3700 4 14.4791 19.2338 39.2972 7.93482 8.11578 -14.4624 -3701 4 14.6855 19.6458 40.7662 17.9566 28.0241 18.1173 -3702 6 14.5596 1.14026 10.2341 26.3279 -2.23148 -9.5451 -3703 4 15.4055 1.22344 9.73443 -17.3894 7.51472 10.761 -3704 4 14.1379 0.381418 9.8097 -7.55267 -3.97863 3.86231 -3705 6 34.4334 40.9199 12.9894 -0.940803 4.29697 -17.7271 -3706 4 34.039 40.5607 12.1545 5.82782 2.6847 22.9711 -3707 4 34.273 40.3011 13.7266 -2.01031 0.481385 -16.696 -3708 6 42.1477 25.6267 33.9881 24.0417 -24.4569 -2.75436 -3709 4 41.6299 25.3559 33.2134 -0.0206438 0.202706 6.41118 -3710 4 42.855 24.9213 34.0976 -22.0628 21.5276 -5.85955 -3711 6 29.1852 22.5895 40.0737 -4.6165 -6.65381 -10.571 -3712 4 28.5947 23.1672 39.581 -0.582997 4.41945 3.85107 -3713 4 29.0675 22.7332 41.0074 -2.93269 3.94269 10.2267 -3714 6 44.8062 18.6252 1.49818 5.72139 3.58279 15.6322 -3715 4 44.9314 18.8801 2.44529 -3.9019 -2.65234 -18.9387 -3716 4 44.0985 19.1782 1.14518 3.29812 2.13948 3.69359 -3717 6 4.47265 10.8135 23.9407 -24.2902 -18.4562 11.3409 -3718 4 5.11906 11.4142 23.6391 22.3407 21.5355 -19.7447 -3719 4 4.51291 10.8829 24.8932 -6.80118 0.381125 6.4492 -3720 6 6.46087 23.0097 28.9948 -0.180046 29.3158 3.74757 -3721 4 7.16357 23.1777 29.6697 -12.977 -15.1924 -17.9731 -3722 4 6.42476 22.0762 28.8013 7.623 -17.0728 6.50296 -3723 6 39.796 25.1427 32.5747 9.70804 -1.04373 -32.2987 -3724 4 39.5377 25.4516 33.4106 -12.9416 11.3784 38.6909 -3725 4 39.6539 25.9218 32.0211 1.09764 -5.16827 -8.54386 -3726 6 40.8629 21.4836 8.86543 0.741147 13.6451 -7.24725 -3727 4 40.6441 21.3431 7.92826 2.29745 -6.5969 8.98303 -3728 4 41.3236 20.7041 9.20266 3.81714 -8.25026 -3.81722 -3729 6 0.635293 1.4289 12.9408 -11.8573 10.3167 -17.0811 -3730 4 54.7874 1.76314 12.6159 9.08744 8.74788 -10.2417 -3731 4 0.270536 0.805051 13.547 10.8795 -21.9384 23.5147 -3732 6 32.6734 29.7199 23.4842 -6.31159 -22.9731 3.95312 -3733 4 32.3164 28.805 23.472 7.37478 14.3791 4.20759 -3734 4 32.5291 29.9779 22.5736 0.738758 10.2783 -10.1223 -3735 6 12.5322 37.1564 20.4866 30.6876 51.3804 29.6269 -3736 4 13.0449 37.1468 21.3313 -10.4644 -1.04639 -16.0138 -3737 4 12.1935 36.3015 20.3752 -17.5174 -49.5479 -6.43685 -3738 6 13.879 14.5208 24.6979 -2.0089 -0.488943 14.0828 -3739 4 13.5126 15.2415 24.1863 -2.86121 7.01781 -5.24136 -3740 4 14.0435 14.8889 25.5812 -0.885703 0.504049 -6.33424 -3741 6 17.5084 27.0547 26.4789 25.7109 3.2743 -38.4356 -3742 4 17.3703 27.9297 26.0618 -4.07905 -12.769 13.7294 -3743 4 18.1097 26.6273 25.8042 -17.4354 5.34049 24.3014 -3744 6 54.4807 9.52867 26.3526 -8.08409 11.5192 21.059 -3745 4 54.0543 10.3952 26.5681 7.59002 -15.9534 -5.94965 -3746 4 54.8701 9.18952 27.1901 -5.85154 7.09102 -14.0848 -3747 6 33.6811 21.5047 24.9231 9.13792 -2.03882 -43.3211 -3748 4 33.6373 21.3676 23.9235 3.71376 4.25849 32.7793 -3749 4 32.846 21.1613 25.2346 -13.4677 -6.75943 10.2286 -3750 6 22.147 35.267 2.89295 -1.50127 3.24452 17.3348 -3751 4 22.2381 34.4 2.47628 0.948748 -2.82555 0.0189077 -3752 4 22.0999 35.1233 3.8735 0.523717 -2.91888 -18.7193 -3753 6 45.3111 5.3951 15.6139 -0.0233827 -18.9082 29.3701 -3754 4 45.1442 5.22798 16.5663 9.63366 2.6406 -14.7931 -3755 4 44.5125 5.84005 15.3428 -8.81534 4.22624 -14.6387 -3756 6 5.67663 7.59044 16.9735 -0.040306 4.08799 -12.5895 -3757 4 5.28026 7.88599 16.128 7.47401 -1.2917 10.5251 -3758 4 6.58383 7.937 17.01 -0.793937 -3.87211 -2.68331 -3759 6 34.58 39.0977 27.2045 1.42769 14.436 -3.31523 -3760 4 34.2907 38.4975 27.863 -0.77861 -26.0942 16.6839 -3761 4 34.0642 39.8725 27.4397 -1.42861 13.6713 -5.6929 -3762 6 32.7657 33.6085 34.293 -22.4583 20.5671 -18.6673 -3763 4 32.1806 34.0441 33.6111 23.9751 -17.2665 15.818 -3764 4 32.4638 34.0082 35.1245 2.30326 -6.42306 -1.86009 -3765 6 30.988 41.2133 32.384 -4.02481 -7.82035 -3.95856 -3766 4 30.2267 41.2202 32.9774 -4.32902 6.50081 -0.328838 -3767 4 31.0509 0.17511 32 -1.2051 10.1503 -2.92525 -3768 6 7.6493 1.59177 27.1464 22.3535 -22.6118 -16.4669 -3769 4 8.41104 1.29664 26.5499 -29.8997 15.2665 16.3611 -3770 4 7.54328 2.53873 27.061 4.65755 9.49162 -4.22239 -3771 6 0.888965 22.101 37.8501 15.4112 -23.8094 -16.9331 -3772 4 1.26739 21.3109 37.3638 -11.0686 24.0488 15.8162 -3773 4 1.18 22.8712 37.3372 -1.61814 -2.27923 2.93708 -3774 6 7.39632 11.121 19.2332 -2.86932 4.41375 3.62624 -3775 4 7.58751 12.0436 19.3904 -7.23274 18.3647 6.41875 -3776 4 8.29083 10.7877 19.1848 5.97481 -12.1861 -3.76707 -3777 6 43.7816 12.5054 37.3126 2.86093 2.78929 -1.28281 -3778 4 43.9727 12.4749 36.3586 -3.06612 0.785718 5.83621 -3779 4 44.6572 12.6706 37.7021 -4.14278 -2.20963 -1.61523 -3780 6 29.0947 33.5132 36.1777 7.61955 17.1376 -26.1106 -3781 4 29.8261 34.0815 35.8667 -13.5031 -6.20718 4.51186 -3782 4 29.4784 33.1216 36.9462 10.9925 -12.9866 20.6523 -3783 6 14.807 4.60084 3.93512 20.0881 9.19657 -13.3363 -3784 4 14.316 4.04064 3.33426 -13.0632 -7.60853 1.79497 -3785 4 15.6236 4.79338 3.42413 -10.111 -0.253003 10.8348 -3786 6 39.0437 6.41097 6.40143 -11.952 4.4329 11.9095 -3787 4 39.4604 7.16771 6.02322 8.12547 27.0605 -0.357881 -3788 4 39.3566 5.75952 5.7919 -0.567413 -21.3616 -5.48613 -3789 6 22.2146 37.9992 40.767 -9.02066 -17.4896 -19.1754 -3790 4 22.494 38.8839 40.5618 6.85259 22.4587 -5.93601 -3791 4 22.4583 37.8811 41.6743 4.99519 -4.33654 23.0463 -3792 6 4.4524 23.286 6.15211 29.8095 -7.21279 -13.1375 -3793 4 3.81791 23.938 6.45512 -14.4589 -6.71938 9.72163 -3794 4 4.31449 22.3781 6.49744 -8.68344 13.1635 4.00749 -3795 6 12.4271 23.7748 9.24631 -1.26755 4.43152 21.3749 -3796 4 11.5607 23.6235 8.88266 -11.7175 -2.77193 -9.11925 -3797 4 12.2509 24.3149 10.0432 11.3809 -1.60307 -13.9136 -3798 6 46.4989 15.2625 16.9679 -12.8481 -2.49131 10.8408 -3799 4 47.085 14.9252 16.2779 8.49272 6.07271 -3.86524 -3800 4 46.8927 16.0486 17.3753 9.61298 -1.72862 -3.23202 -3801 6 34.1182 27.164 19.7815 17.9289 -11.392 6.58771 -3802 4 34.8637 26.5005 19.7508 -17.7467 14.3364 5.12367 -3803 4 34.0077 27.4664 20.702 3.31322 -6.80894 -12.4792 -3804 6 46.9518 13.2225 35.1059 11.5726 -0.299351 34.0182 -3805 4 47.3951 14.0533 34.9197 -1.30218 2.22738 -12.772 -3806 4 46.5273 12.8898 34.3328 -6.46075 0.0352155 -21.0879 -3807 6 50.5846 18.7905 12.5321 0.161349 -2.47544 -10.5355 -3808 4 49.7474 18.3698 12.2516 10.3296 3.30344 0.704295 -3809 4 51.1853 18.7954 11.7538 -11.6392 0.795373 7.80699 -3810 6 32.4849 12.6316 31.9547 13.623 -32.1984 -17.1952 -3811 4 32.7548 11.6805 31.9646 -3.77817 17.5545 -6.43374 -3812 4 32.3724 12.7906 32.8759 -7.39939 11.2146 27.5789 -3813 6 6.21204 19.6856 10.0139 6.84548 18.8235 13.1049 -3814 4 6.54027 20.2383 9.28123 0.761161 -1.37122 2.72757 -3815 4 6.08461 20.3138 10.7689 1.69871 -13.3343 -16.4193 -3816 6 21.5267 21.5372 2.4283 -5.72751 11.2346 -5.82425 -3817 4 21.7624 21.5115 1.48057 4.80944 -6.6677 9.03128 -3818 4 21.9699 20.8013 2.88237 1.68469 2.19074 -10.3234 -3819 6 38.389 23.0803 17.19 -15.8009 11.2489 14.8144 -3820 4 38.843 23.3405 16.3672 7.30113 -17.2523 7.40945 -3821 4 38.5581 22.1678 17.4979 8.57434 6.38113 -15.3203 -3822 6 29.7009 24.9705 22.2505 40.9979 -45.9373 -29.6811 -3823 4 30.2007 24.9541 23.0531 3.51493 7.58579 28.6285 -3824 4 28.9709 25.5198 22.3387 -45.941 40.092 17.1582 -3825 6 30.3026 21.4444 37.7784 -57.0222 17.1687 -23.3742 -3826 4 30.3615 21.3347 36.805 9.38026 -2.23221 21.4717 -3827 4 29.3011 21.6413 37.9016 49.3444 -12.8915 1.59191 -3828 6 11.8723 11.7062 16.3108 -33.4349 -15.0686 -41.1118 -3829 4 11.3207 12.2631 16.8681 -3.98396 2.02201 -1.40695 -3830 4 11.3108 11.5232 15.4705 24.8968 9.48818 41.0096 -3831 6 5.70652 16.9717 10.4705 4.17204 -12.2255 5.26049 -3832 4 4.89872 17.0293 11.0039 1.44556 1.21447 -8.81597 -3833 4 5.85075 17.8293 10.0626 -3.65007 4.58518 2.58079 -3834 6 41.6977 34.1692 35.8837 -2.16171 7.35997 35.3278 -3835 4 41.9434 35.0359 36.2767 -7.39108 -12.3774 -11.2945 -3836 4 41.6554 34.2509 34.9408 0.248654 6.88642 -24.6778 -3837 6 33.755 1.15956 30.1148 26.9661 -5.30311 0.785489 -3838 4 32.8327 1.41064 30.2749 5.35845 -2.81639 19.5818 -3839 4 34.3082 0.981132 30.9387 -30.8845 7.54253 -18.2089 -3840 6 50.3537 18.6141 36.9811 22.0078 18.2711 -1.17075 -3841 4 50.0553 18.9081 37.8421 -3.0234 4.11827 7.26126 -3842 4 49.7241 17.9789 36.6994 -26.7065 -28.1871 -12.5747 -3843 6 24.6713 24.2747 40.2422 -22.5478 13.5437 8.83718 -3844 4 23.7682 24.4281 40.6159 16.469 -5.34198 -8.29501 -3845 4 24.8078 23.3187 40.2616 -1.76472 2.5507 -0.358513 -3846 6 37.3089 22.0315 23.2412 -5.67505 16.6134 8.34505 -3847 4 36.9227 21.8066 24.1113 8.4343 -8.15598 -10.5545 -3848 4 37.8295 21.3076 22.8826 1.63944 -5.88141 4.04288 -3849 6 48.4175 40.505 28.9613 -8.44239 17.3351 -31.8351 -3850 4 48.9168 41.2502 28.5701 -3.67522 -6.90368 3.5913 -3851 4 47.6498 40.4225 28.3398 9.75729 -4.39015 14.633 -3852 6 24.8456 8.73476 16.5822 -4.20971 0.107082 12.7896 -3853 4 25.4166 9.33437 17.0882 0.801486 -3.84637 -6.6671 -3854 4 25.3552 7.93888 16.3774 1.47583 -1.66023 -1.71228 -3855 6 19.2415 22.9983 32.4591 18.0731 -7.21062 -7.32059 -3856 4 18.4972 23.4837 32.0941 -3.55414 -1.2008 3.19393 -3857 4 18.9283 22.447 33.1757 -6.31405 0.951806 3.86493 -3858 6 3.33315 21.6719 22.4471 -31.3651 -15.1442 10.7623 -3859 4 2.72119 22.0562 23.134 20.4737 -7.45649 -18.1084 -3860 4 4.09369 22.238 22.38 14.9219 12.7334 2.89238 -3861 6 10.2287 20.327 12.827 -13.2346 -13.5387 -5.73443 -3862 4 9.59835 20.9044 13.2794 3.30523 -1.6991 -3.3419 -3863 4 9.66163 19.6709 12.3619 8.96671 11.3846 7.22783 -3864 6 9.52445 0.665703 25.3447 51.6699 36.9138 -22.1471 -3865 4 10.407 0.70007 25.8038 -28.3091 -11.588 2.11711 -3866 4 9.73816 1.30323 24.5834 -23.5062 -26.9191 23.3279 -3867 6 10.6629 40.7098 9.64162 -13.7092 -10.0604 -17.7529 -3868 4 10.6663 41.3337 10.3633 -2.25222 9.44489 9.13119 -3869 4 9.9177 40.9644 9.04966 14.1089 -1.91013 12.7496 -3870 6 46.3583 25.2138 32.6818 -7.00173 28.401 24.5039 -3871 4 46.1658 26.0815 33.1748 9.63216 -40.3762 -24.4036 -3872 4 46.6683 25.4845 31.8081 -0.340565 -0.626762 -0.366217 -3873 6 38.9398 3.19835 23.1062 35.7507 -3.98021 4.80576 -3874 4 38.0789 3.42388 22.7807 -21.691 0.0477325 0.592254 -3875 4 38.9606 2.6551 23.9199 -14.9585 3.95725 -7.0779 -3876 6 33.3518 23.6324 36.8776 -10.909 11.1506 22.2396 -3877 4 32.7475 23.7189 37.6717 16.9933 -10.7727 -23.1962 -3878 4 33.5054 24.5617 36.6454 5.48307 -3.56245 -8.14833 -3879 6 51.9403 33.327 25.4307 18.0164 46.0043 -41.5452 -3880 4 51.481 33.1217 26.2288 -14.6019 -1.8433 25.1586 -3881 4 51.8744 34.3335 25.2555 2.07578 -44.1738 12.4077 -3882 6 32.1773 25.016 33.1611 -3.65323 12.5958 -4.40686 -3883 4 32.7417 25.8243 33.1248 -13.2213 -13.5953 2.20315 -3884 4 31.2567 25.3353 32.9959 15.6883 -4.24783 1.324 -3885 6 51.2804 27.7082 39.5058 -12.4055 -13.8576 13.4454 -3886 4 51.6333 27.8214 38.6405 7.56348 -1.28822 -27.9214 -3887 4 51.668 28.4332 39.9759 4.38661 13.1583 16.7532 -3888 6 34.2776 28.325 17.2612 18.5433 -9.6807 0.726105 -3889 4 33.4618 28.7621 17.0499 -21.6526 10.7978 2.5619 -3890 4 34.2928 28.1986 18.2187 -4.64072 -2.98555 4.57564 -3891 6 36.914 8.0422 37.8636 -11.4128 -16.3489 28.1347 -3892 4 37.1972 8.46051 37.0352 12.2245 9.0272 12.2411 -3893 4 37.2151 8.41454 38.7513 -7.64029 -1.69915 -40.4466 -3894 6 34.8876 19.4054 6.12727 15.6033 7.52257 2.15709 -3895 4 34.0531 18.9355 6.15655 -6.74313 -1.04378 -1.75599 -3896 4 34.6977 20.3552 6.00766 0.606543 -4.24654 -1.2187 -3897 6 52.9513 9.46866 7.83406 2.51792 52.5995 -46.1577 -3898 4 52.8182 10.1965 7.1313 21.8169 -33.4663 26.408 -3899 4 52.1097 9.49548 8.25498 -20.9439 -11.3984 23.93 -3900 6 36.2784 5.48477 38.9735 -18.6298 -4.41122 2.56352 -3901 4 36.9459 5.47799 39.6359 15.3203 -14.8264 18.8091 -3902 4 36.5882 6.23606 38.5023 -2.18903 24.2959 -30.3279 -3903 6 10.0091 14.4595 13.4727 4.14065 20.8003 14.1725 -3904 4 10.1735 15.3719 13.8184 -7.35802 -17.2864 -8.75733 -3905 4 9.20522 14.5177 12.9398 -1.57173 0.82324 -0.279823 -3906 6 17.2166 24.3595 39.7866 10.3316 -24.6644 9.74438 -3907 4 16.8461 25.2181 39.6219 -11.8102 15.8188 2.99696 -3908 4 16.9967 24.0978 40.7081 2.51259 6.67153 -9.86646 -3909 6 49.0842 32.5535 7.76087 3.66191 -12.3496 8.85055 -3910 4 48.2705 33.0417 7.89853 -4.87459 2.09702 3.01394 -3911 4 49.5463 32.9698 7.04629 8.35168 7.01386 -14.6239 -3912 6 44.8849 24.3899 5.46806 25.9844 8.68062 13.8603 -3913 4 44.662 24.5947 6.37974 6.74107 7.22813 10.7323 -3914 4 44.0754 24.0079 5.20592 -32.7636 -20.0017 -25.3594 -3915 6 37.3054 29.188 32.8461 11.1431 -5.59449 16.1726 -3916 4 36.8523 29.4202 33.6742 6.83247 1.44061 -4.51415 -3917 4 36.6742 29.3068 32.1579 -22.7291 3.94299 -14.9304 -3918 6 0.907991 24.8221 21.2346 15.0832 19.7352 -4.57067 -3919 4 1.06453 25.2816 20.3717 -1.39622 -8.03116 21.3543 -3920 4 1.45755 25.2897 21.9154 -11.7661 -11.1398 -13.6241 -3921 6 53.0192 2.206 13.0014 -0.818186 11.5483 2.08343 -3922 4 52.7824 1.81345 13.8314 -6.90556 -15.4066 8.50991 -3923 4 53.4537 3.0128 13.31 2.83183 5.68595 -7.528 -3924 6 24.3052 33.9756 13.9324 20.4312 -11.5489 10.0229 -3925 4 23.7773 33.1726 14.1229 5.8111 10.1191 -2.33499 -3926 4 25.2169 33.8698 14.327 -30.0349 3.28274 -10.0023 -3927 6 40.9302 19.2912 0.318024 -15.3988 27.4065 1.86032 -3928 4 41.1581 18.3902 0.297675 9.36546 -44.4479 -0.119704 -3929 4 41.7646 19.7516 0.396104 7.20249 9.57203 1.55489 -3930 6 38.311 32.026 21.5914 -16.5672 24.1097 -12.7773 -3931 4 37.7777 31.3762 21.1012 4.07846 0.69211 1.97712 -3932 4 37.9765 32.9287 21.3171 8.34414 -28.994 10.9395 -3933 6 42.3062 34.9979 16.9676 -25.16 18.3345 5.87282 -3934 4 41.5364 35.0784 17.5803 19.0968 -0.611651 -8.13832 -3935 4 42.7061 34.1505 17.1117 7.13758 -14.417 1.0169 -3936 6 19.559 24.3289 21.9471 -10.3882 -39.985 28.3228 -3937 4 19.0651 23.5074 22.2416 22.0177 25.9498 -5.97634 -3938 4 18.911 24.732 21.3859 -10.0006 10.9377 -12.5795 -3939 6 21.0734 3.08215 14.9508 5.66735 1.93263 4.27485 -3940 4 21.953 3.50152 15.1067 -15.9394 -6.36392 -7.95302 -3941 4 20.9814 2.87634 14.0019 2.73511 2.88399 3.27523 -3942 6 16.4416 12.1461 28.5328 0.855962 3.79198 1.54672 -3943 4 16.9672 12.6551 29.168 -2.37031 -0.949071 -4.41291 -3944 4 15.802 12.7688 28.1665 0.405815 -3.95107 1.98596 -3945 6 29.5641 4.71626 21.7415 17.492 -20.3905 -14.0863 -3946 4 29.717 3.79719 21.4198 0.937107 17.7735 8.56359 -3947 4 28.6765 4.939 21.4721 -9.06619 5.19467 -0.439365 -3948 6 47.4133 12.088 13.4013 -19.6032 -12.6622 16.1152 -3949 4 46.7677 12.2286 12.6843 7.8139 0.82382 7.69043 -3950 4 46.8958 11.6888 14.1608 19.5987 16.3505 -27.3211 -3951 6 26.4348 0.0314913 5.59163 -38.6673 11.9556 1.59378 -3952 4 25.5144 0.513751 5.59151 44.3701 -31.5426 2.21012 -3953 4 26.2832 40.9933 5.84663 -4.6239 23.4679 -5.56234 -3954 6 20.8211 34.8097 41.3598 6.97593 19.5597 16.9804 -3955 4 20.8796 35.753 41.6458 -3.00787 -20.9192 -8.75426 -3956 4 21.5767 34.358 41.784 -4.89338 4.10004 -2.4608 -3957 6 12.6876 17.479 1.38718 -1.79098 16.5747 12.6529 -3958 4 12.721 17.2085 2.3151 1.79447 -6.15344 -4.56661 -3959 4 12.6249 16.7029 0.834077 -0.882684 -12.7315 -6.97767 -3960 6 30.0809 10.1879 8.41184 2.17826 -2.71045 -21.4672 -3961 4 29.3744 10.7602 8.07412 2.70218 -2.7161 1.39802 -3962 4 29.921 10.0821 9.33998 -2.4398 0.0699553 19.6849 -3963 6 36.338 5.45526 23.9203 5.99313 10.0946 16.1749 -3964 4 36.1182 6.35936 23.6236 3.48165 -5.42435 1.21963 -3965 4 37.0503 5.55216 24.5976 -11.7354 -2.45534 -11.6386 -3966 6 34.0137 39.9398 19.5054 17.9066 -9.75089 21.0607 -3967 4 34.5988 39.5452 20.1731 -15.7075 -1.02338 -1.83906 -3968 4 34.6431 40.5289 19.082 -7.6391 9.5881 -14.1485 -3969 6 25.1112 29.0201 17.0007 35.0878 36.529 -22.1514 -3970 4 24.4917 28.3695 17.2244 -30.3786 -36.8419 16.5077 -3971 4 24.8604 29.2867 16.1023 2.15056 -2.21883 6.37313 -3972 6 28.5036 21.3308 6.52422 21.0338 -5.55128 30.7615 -3973 4 28.0688 21.6386 5.71574 5.06238 16.4658 -0.926129 -3974 4 28.989 22.0506 7.05137 -24.5794 -13.751 -30.0602 -3975 6 18.6637 26.1498 0.432001 -8.53447 25.4727 10.2843 -3976 4 18.1393 25.3713 0.533905 -9.92127 -26.6833 -5.54807 -3977 4 18.1707 26.7698 1.00478 10.6071 3.27379 -7.60185 -3978 6 10.9817 29.7047 15.4617 -41.5317 11.7513 13.4553 -3979 4 11.6879 29.3608 14.9846 35.2501 -21.9962 -32.1318 -3980 4 11.3889 29.9926 16.2601 5.02956 8.45945 23.8164 -3981 6 33.4827 3.76017 10.5773 -2.41261 -0.304069 24.838 -3982 4 33.4731 3.39919 11.5182 2.46452 11.5285 -31.0446 -3983 4 33.5847 4.73535 10.6555 -0.240223 -15.9168 2.16837 -3984 6 12.2973 28.805 23.0387 -1.70787 -5.55619 5.61474 -3985 4 12.73 29.6571 22.9381 2.67417 5.94729 -0.690524 -3986 4 11.5024 28.994 23.5653 2.03311 -0.198261 -3.05575 -3987 6 13.0915 10.291 41.0216 -35.9662 5.53295 8.52282 -3988 4 13.8386 10.0408 41.5246 29.6538 -8.48465 17.7322 -3989 4 13.4107 10.5366 40.1733 8.17866 7.18603 -23.992 -3990 6 45.8162 29.981 22.3537 -23.4909 -34.782 -9.94688 -3991 4 46.3605 30.6906 22.6479 19.8522 18.211 11.3118 -3992 4 46.1638 29.1315 22.7274 -3.04842 19.9099 -5.39144 -3993 6 41.5671 12.1372 14.78 12.0724 6.03101 -10.0784 -3994 4 40.8481 12.1001 15.4119 -11.2612 -2.38036 6.73971 -3995 4 41.9114 13.0311 14.8874 5.93112 4.19505 -0.667369 -3996 6 18.1729 7.20363 24.1739 -28.0382 48.7978 3.52623 -3997 4 17.4064 7.85498 24.128 33.406 -18.9268 -1.93395 -3998 4 17.7199 6.38321 24.1568 -14.2968 -40.16 -0.285645 -3999 6 1.47767 28.308 7.57167 -25.5616 27.2209 -25.1393 -4000 4 0.827452 27.622 7.68711 2.49251 -16.9659 6.86802 -4001 4 0.906232 29.0217 7.18328 24.331 -5.18373 6.93061 -4002 6 11.3359 12.3164 24.0718 -23.8013 37.4997 -14.7667 -4003 4 11.6691 13.0224 24.6595 3.51665 -15.1291 3.43827 -4004 4 11.6925 11.4858 24.3227 20.8697 -21.176 20.4973 -4005 6 17.9852 40.4684 24.4198 -2.05389 -13.7174 33.2687 -4006 4 18.291 40.9889 23.6947 8.79563 24.1615 -11.819 -4007 4 17.8495 41.0209 25.2243 7.13458 -7.65509 -20.9696 -4008 6 25.5964 7.43792 34.0141 13.5012 12.0052 -20.5927 -4009 4 25.8913 7.969 33.2287 -3.90825 -14.1502 17.4414 -4010 4 24.6674 7.63663 34.1466 -9.57807 0.741149 3.27376 -4011 6 16.9692 36.3856 7.79034 -41.9934 -28.8773 9.66508 -4012 4 16.1027 35.9203 7.98218 37.4859 8.56847 -14.648 -4013 4 16.8197 37.2026 8.24874 12.7807 20.325 5.07796 -4014 6 12.4125 39.1679 36.8113 4.83627 -30.6012 -9.1357 -4015 4 13.2866 39.4994 36.9682 3.20673 22.8904 8.84646 -4016 4 12.7018 38.3069 36.4569 -23.4958 5.90479 1.90955 -4017 6 23.4443 1.91649 37.7131 1.30421 0.985484 -2.89526 -4018 4 22.7028 1.66545 37.1374 7.60384 11.2995 4.79583 -4019 4 23.7753 2.79308 37.4363 -6.35903 -5.24233 -3.11404 -4020 6 26.6169 34.8556 39.068 -18.8945 24.0174 -16.1573 -4021 4 25.9011 35.0209 39.7003 9.00825 -5.11239 -0.809586 -4022 4 26.448 35.531 38.356 7.64302 -20.2436 14.8851 -4023 6 44.7566 35.572 23.174 8.53117 -4.94531 -21.3447 -4024 4 44.5551 36.3183 23.7275 -7.66893 11.3086 12.1688 -4025 4 44.9082 35.9286 22.2729 -0.906387 -11.1819 10.3159 -4026 6 34.6091 35.4265 26.6991 -7.96701 8.74937 -1.29134 -4027 4 33.7558 35.2865 27.1578 16.0802 3.93421 -4.37465 -4028 4 35.2785 35.5457 27.4013 -9.86041 -2.80018 -4.60569 -4029 6 12.4308 29.8402 9.37325 4.00701 15.5633 13.1387 -4030 4 12.6298 30.2095 10.2592 0.427445 -8.8693 -11.9579 -4031 4 11.9163 30.5385 8.94302 -0.259504 -4.09781 -0.505047 -4032 6 46.4536 41.3715 16.9585 -0.509472 -10.7221 -3.48983 -4033 4 46.3968 0.20327 17.5639 0.209317 7.43894 6.10767 -4034 4 46.3711 41.769 16.0793 0.075994 -2.20044 0.741492 -4035 6 39.1811 31.047 24.0166 -28.3946 14.7902 -31.7872 -4036 4 39.0009 31.2944 23.0615 15.0891 -8.50563 28.3067 -4037 4 38.282 31.1199 24.3765 13.6746 -2.33731 7.34059 -4038 6 40.5375 9.75603 28.9763 9.47615 -22.8392 -16.3574 -4039 4 40.717 8.78834 28.9749 -4.02124 18.0325 0.597023 -4040 4 40.0442 9.94417 29.7674 -4.45736 4.50836 13.2228 -4041 6 33.5752 11.9033 22.735 -22.7947 23.9621 15.9921 -4042 4 33.2963 12.1808 21.8555 7.18969 -8.33444 -8.87292 -4043 4 33.0376 12.5465 23.2695 22.9257 -24.0379 -3.52442 -4044 6 29.0301 38.739 2.44557 13.7604 -11.9544 -20.6568 -4045 4 29.2066 39.6607 2.23242 1.09325 2.62923 1.14408 -4046 4 28.4566 38.7797 3.20164 -8.68487 1.4276 10.4377 -4047 6 51.2789 6.14828 28.303 0.614736 -0.570337 1.8431 -4048 4 51.6973 5.27456 28.1665 -1.53436 11.093 -0.261734 -4049 4 51.6265 6.73477 27.6091 2.17001 -12.1019 4.10374 -4050 6 34.1129 16.6124 14.0322 -32.0491 -20.8609 -4.49638 -4051 4 33.8537 17.5241 13.9801 -4.99199 17.3104 -1.82528 -4052 4 35.0495 16.5739 14.0336 36.3732 5.94549 -0.19423 -4053 6 34.4398 40.0505 7.51971 -1.5967 1.86622 -34.5907 -4054 4 34.4907 40.736 6.82898 6.47702 11.7366 29.0204 -4055 4 34.1466 39.3906 6.89306 -3.09667 -23.6565 15.965 -4056 6 42.5416 22.9885 4.36731 16.709 1.02816 -9.65968 -4057 4 42.6773 23.0677 3.40021 -12.3994 2.37358 9.8727 -4058 4 41.6332 23.2481 4.59133 5.34809 1.54884 -5.45539 -4059 6 1.43335 11.7249 10.5915 17.9648 34.7983 -1.93775 -4060 4 2.18855 11.6351 9.93392 -25.2532 9.63542 18.7746 -4061 4 1.3761 12.7012 10.8984 13.7257 -41.7135 -20.7702 -4062 6 10.0197 17.1509 40.4023 -3.34945 -21.541 12.0793 -4063 4 9.07741 16.8499 40.449 26.596 5.40866 2.75879 -4064 4 10.6028 16.482 40.874 -24.6204 18.7768 -14.392 -4065 6 26.3793 1.16939 23.7984 9.5834 26.112 -20.0106 -4066 4 26.3482 1.63114 22.915 -1.08564 -15.7005 23.7132 -4067 4 26.8817 1.81632 24.3342 -3.35925 -10.5223 -0.68284 -4068 6 4.47487 16.2271 39.0058 33.4959 -10.553 -10.6989 -4069 4 4.63618 15.8937 38.0801 -2.33968 7.70086 24.4633 -4070 4 5.35244 16.1813 39.5129 -32.5033 1.65679 -19.7071 -4071 6 24.3835 39.8482 14.0852 2.84697 7.18038 -0.286146 -4072 4 24.1877 40.6985 13.6429 5.77715 -11.144 2.19115 -4073 4 25.1234 39.4426 13.6288 0.754333 1.29636 -3.16103 -4074 6 19.9701 19.0136 10.1131 -5.22385 -12.8057 23.8822 -4075 4 19.1001 19.3633 10.3498 -0.643873 5.13605 -7.14836 -4076 4 20.1315 18.3631 10.8504 3.64009 16.176 -24.2707 -4077 6 45.2329 15.0638 25.3099 -19.5547 20.2245 12.2671 -4078 4 44.4482 15.622 25.4263 4.62838 7.04728 2.57625 -4079 4 44.8851 14.3824 24.752 0.155489 -22.5403 -14.0061 -4080 6 47.6439 32.9533 29.9771 4.38746 -1.69347 6.40492 -4081 4 47.8622 32.5347 30.8309 -5.05982 6.77924 -7.14273 -4082 4 46.6855 33.0215 29.8843 -3.06966 -4.44082 4.14054 -4083 6 9.30872 14.1631 35.6268 19.7088 14.7601 29.7215 -4084 4 10.221 13.8687 35.4779 -5.99131 -8.3331 -9.89462 -4085 4 9.36538 14.5282 36.5395 -10.4264 -5.45721 -18.9107 -4086 6 0.534978 28.7509 32.1461 -15.0727 14.1973 -4.1115 -4087 4 0.468283 29.1163 31.2513 -2.72678 6.96628 5.64212 -4088 4 0.834469 27.866 31.9601 7.81775 -11.1437 7.49829 -4089 6 26.1375 14.1816 40.8286 20.1166 -40.7048 30.4826 -4090 4 26.3241 13.5573 41.5993 3.0023 20.8863 -27.3959 -4091 4 25.2151 14.3343 40.9319 -22.5068 13.4131 -3.44564 -4092 6 38.0468 1.72227 37.358 -19.6589 11.4537 -4.22791 -4093 4 38.2764 1.77906 36.4154 -1.14244 -2.14966 7.97792 -4094 4 37.182 2.20858 37.4052 20.9639 -13.8426 2.93072 -4095 6 43.3928 21.0193 0.385094 -33.4221 -4.11839 13.5226 -4096 4 43.2305 21.8771 0.864972 20.5484 -13.2955 -16.2126 -4097 4 44.243 20.9573 41.8451 7.78799 18.4844 3.58779 -4098 6 29.7343 12.3918 17.0888 -10.4088 14.6249 -44.7733 -4099 4 30.3573 13.1084 17.3121 -1.69191 -12.5137 15.8564 -4100 4 29.5365 11.7717 17.7855 9.28071 1.18848 24.195 -4101 6 21.0845 11.002 35.643 19.2467 11.9534 29.728 -4102 4 20.8387 11.9292 35.5336 -5.23529 -0.657509 -1.91086 -4103 4 20.6782 10.509 34.9529 -15.7216 -13.7754 -25.5995 -4104 6 24.3584 22.1274 17.054 -19.116 4.6391 -13.6617 -4105 4 24.8062 22.8618 16.6504 0.246813 15.5697 -7.02352 -4106 4 25.0581 21.6899 17.4914 19.3443 -19.237 19.9016 -4107 6 44.2632 9.62803 6.15095 12.4515 -7.11379 4.41615 -4108 4 44.6939 9.46248 5.31272 4.1824 -3.3463 -6.13814 -4109 4 43.3875 9.94101 5.94426 -13.441 6.05535 2.74078 -4110 6 40.7983 2.89203 6.29118 6.30341 -5.06299 2.94692 -4111 4 40.283 3.08384 7.0886 -2.93464 8.08246 -11.2803 -4112 4 40.6425 3.53992 5.58152 -5.48248 3.30556 7.46891 -4113 6 23.4927 29.787 25.2074 -17.9847 -14.6764 23.1638 -4114 4 22.9663 29.9524 24.4255 0.505661 2.84572 -7.25135 -4115 4 24.3189 30.243 25.1366 19.4862 15.0746 -12.06 -4116 6 45.2253 20.6067 7.48804 -4.5495 -5.9569 -0.737791 -4117 4 44.4771 20.6075 6.85512 7.98227 -4.73543 5.3389 -4118 4 45.4897 19.6858 7.65762 -3.7219 7.49041 -4.48952 -4119 6 44.1869 26.5802 16.6604 -2.53584 -23.4697 22.3036 -4120 4 44.4278 26.4187 15.7655 11.491 9.41288 -34.0672 -4121 4 43.9629 25.6676 16.9 -3.51956 3.82806 13.7521 -4122 6 23.5847 27.0608 18.0875 4.92857 -1.63386 -8.1099 -4123 4 23.1417 26.2886 17.6568 -1.85204 16.5134 12.3838 -4124 4 22.9956 27.5067 18.7318 1.2523 -15.787 -12.8337 -4125 6 45.1423 16.1006 8.91925 -12.5826 4.07054 -12.5551 -4126 4 44.1756 16.0018 8.7625 13.8686 2.25455 7.61002 -4127 4 45.2849 15.9649 9.86163 -1.87368 -3.25302 7.37304 -4128 6 39.0195 15.168 5.20911 22.9796 -5.95468 -13.3261 -4129 4 39.8169 15.5451 4.76197 -16.8333 -0.501818 4.44847 -4130 4 38.2997 15.7872 5.12886 -6.79784 14.0419 -3.1922 -4131 6 40.4728 4.77172 20.098 -25.5728 -7.96759 5.38455 -4132 4 41.2852 4.73631 19.62 25.1414 0.345713 -9.53623 -4133 4 40.6586 5.20983 20.9254 2.90807 4.2574 9.49937 -4134 6 35.8334 28.4358 39.8978 -29.6544 -30.7382 0.627816 -4135 4 35.064 27.7738 39.8775 30.8234 30.4338 1.60118 -4136 4 36.4992 28.0138 39.3349 2.0747 -0.608826 -0.916217 -4137 6 26.5626 3.56604 2.67563 -12.8067 -1.70274 -2.52813 -4138 4 26.0244 3.493 1.8476 6.72613 8.7381 24.6483 -4139 4 26.0719 4.09981 3.36162 5.66066 -13.1585 -23.5937 -4140 6 2.95645 21.6514 17.6824 -3.82104 6.40043 0.291571 -4141 4 2.91294 22.1823 18.4797 -6.37673 0.600795 10.7096 -4142 4 3.68258 22.033 17.1814 1.62588 2.51689 -6.09233 -4143 6 12.886 25.0591 25.9256 19.9254 19.7817 -8.37483 -4144 4 13.3104 25.904 25.618 -13.2675 -16.998 3.60223 -4145 4 12.0452 24.9678 25.4656 -4.65807 1.85418 -5.64346 -4146 6 41.5793 20.6554 14.1751 9.92193 3.46069 0.25892 -4147 4 42.3122 20.2044 13.7523 0.767115 -12.7084 -7.64783 -4148 4 41.9959 21.4893 14.4245 -8.84771 2.34114 1.73285 -4149 6 1.24495 39.6039 11.5378 16.0363 -42.6363 3.17437 -4150 4 1.64626 38.7705 11.134 -18.3255 36.4754 4.46196 -4151 4 1.41802 39.4632 12.4909 -5.9615 12.3362 -8.98123 -4152 6 16.0218 39.0109 34.0619 -0.331369 12.6721 -5.4452 -4153 4 15.5475 38.1996 33.7806 5.75571 19.7523 -4.5346 -4154 4 15.9899 39.7855 33.4251 -7.29137 -28.599 9.21448 -4155 6 20.567 7.02475 25.5588 2.3848 7.82756 -0.6535 -4156 4 20.909 7.86076 25.1782 -7.45606 -9.2474 3.61042 -4157 4 19.6275 6.99553 25.3185 5.42042 5.25175 -3.5088 -4158 6 45.1928 25.5902 39.1787 -21.925 2.17874 18.9559 -4159 4 45.8631 26.0435 38.6892 20.8233 13.1115 -15.3132 -4160 4 45.3324 24.6675 39.0115 4.42968 -17.7425 -2.36405 -4161 6 19.9342 40.1138 28.2835 12.5964 -14.0671 -7.25792 -4162 4 19.0067 40.1593 28.0096 1.46425 5.68018 7.52545 -4163 4 20.128 40.8224 28.917 -7.48392 0.334406 -3.99949 -4164 6 26.4878 14.2069 27.3684 6.98603 -7.23951 -28.1548 -4165 4 25.5412 14.1932 27.2537 -20.7302 0.754551 -2.34698 -4166 4 26.606 14.4537 28.2745 0.836708 4.29804 26.5652 -4167 6 51.3489 25.9487 3.45136 10.7849 20.7191 -13.686 -4168 4 51.0453 25.2386 4.01334 -1.8549 -15.8565 1.21982 -4169 4 51.853 25.5737 2.69356 -6.32678 0.0553236 13.0587 -4170 6 20.1633 26.1247 2.67289 8.83438 -16.1267 5.68002 -4171 4 20.5345 25.2411 2.88723 -1.43181 13.9101 -1.64203 -4172 4 19.9438 26.1088 1.72974 -0.778515 0.427063 3.21599 -4173 6 3.13549 11.9681 27.2232 16.3616 22.3682 9.86323 -4174 4 2.68005 12.663 26.7181 4.92926 -3.58697 -0.471129 -4175 4 3.70389 12.4466 27.8862 -15.0224 -10.9098 -14.9284 -4176 6 30.1793 26.3687 4.00051 28.7119 -30.2966 58.1206 -4177 4 30.7801 25.8341 3.46925 -1.584 2.83444 -17.1702 -4178 4 29.6371 26.9341 3.51662 -25.563 30.6813 -37.7958 -4179 6 19.3205 20.6733 30.5441 -31.721 -6.25106 8.6959 -4180 4 19.1895 21.5008 31.0287 11.509 1.10551 -1.6952 -4181 4 20.2026 20.5869 30.2 22.6938 9.52703 -0.947482 -4182 6 13.5381 36.2475 0.344803 0.685356 24.2985 -17.2657 -4183 4 13.9232 37.1122 0.0997808 14.0363 -10.2996 17.9143 -4184 4 12.867 36.2368 41.5779 -17.3214 -19.7281 -1.62589 -4185 6 13.6931 21.7661 35.9637 -11.3229 -11.9655 -19.5688 -4186 4 13.4645 21.416 35.0694 1.68887 6.71419 14.5774 -4187 4 14.5559 22.1488 35.8465 12.3178 6.48213 0.887249 -4188 6 39.4176 1.76287 25.342 34.0854 -16.9064 9.57103 -4189 4 40.0026 2.33061 25.8435 -14.6367 28.4588 7.32056 -4190 4 40.0689 1.04185 25.2643 -19.5027 -7.65211 -10.5764 -4191 6 18.2964 6.13492 35.8264 -1.82227 -5.92686 -23.3299 -4192 4 18.1639 5.26767 36.254 2.04199 12.8657 6.45456 -4193 4 18.4232 6.85005 36.4651 0.375802 -9.94466 7.47089 -4194 6 2.53148 24.639 10.0969 -49.4669 34.6161 -0.50772 -4195 4 3.3243 24.1433 10.0889 43.7683 -7.59463 9.24933 -4196 4 2.65209 25.5465 10.4987 14.0059 -27.2835 -7.72375 -4197 6 35.8204 9.94567 1.34298 17.6587 14.9905 11.506 -4198 4 36.311 10.4135 0.64327 -4.10869 -3.12473 7.53129 -4199 4 36.1923 10.315 2.19711 -13.0886 -16.0695 -26.9686 -4200 6 29.0171 17.933 41.5847 -7.4648 10.4738 41.1296 -4201 4 28.4325 17.2741 41.1888 4.90819 -0.226834 -17.309 -4202 4 29.634 18.3354 40.9804 6.59061 1.40283 -25.0927 -4203 6 46.0097 27.0807 25.8707 -17.7195 2.90801 -6.40423 -4204 4 46.7639 26.9189 26.4445 5.86789 -6.79057 7.62258 -4205 4 45.3727 26.3443 25.9794 8.73043 2.74283 1.98831 -4206 6 28.1087 10.6569 35.9055 -15.3417 -26.5964 -30.9314 -4207 4 27.3182 11.0018 35.4375 11.5227 2.30745 10.116 -4208 4 28.4572 11.2922 36.5111 4.26863 23.9808 15.1461 -4209 6 25.95 20.1976 24.7821 3.31321 9.63686 -4.79579 -4210 4 26.7637 20.7132 24.6155 -9.40037 -7.04512 10.7501 -4211 4 25.7749 20.1865 25.7378 6.19451 4.49283 1.81458 -4212 6 32.2481 30.2487 10.2005 -0.567171 -33.888 25.4585 -4213 4 32.5217 30.8918 9.54162 14.407 -2.03846 -6.18424 -4214 4 32.9483 29.5597 10.4163 -8.30199 27.6945 -16.8968 -4215 6 5.04696 34.3919 23.8165 18.9071 9.10073 -2.65681 -4216 4 5.8517 34.9395 23.7378 -5.43375 -12.4066 7.00495 -4217 4 4.47737 34.8578 23.2154 -15.6684 -1.23826 -5.97721 -4218 6 29.6446 34.9396 23.1073 8.37026 13.2143 1.46186 -4219 4 30.146 35.227 23.8877 -4.79805 -2.96005 -2.8646 -4220 4 29.6355 33.9874 23.1398 -0.169507 -13.2925 4.62646 -4221 6 52.2021 25.2197 36.2484 0.203165 -13.9358 18.8619 -4222 4 51.9199 25.3821 37.1814 5.20177 -0.668093 -22.6011 -4223 4 52.2823 24.2449 36.2046 0.468647 8.20491 -0.432122 -4224 6 6.9564 41.2598 14.9786 17.963 -12.3423 -19.5336 -4225 4 7.05881 41.0384 15.8913 -5.14113 -1.34859 16.0369 -4226 4 7.66895 40.7276 14.5577 -14.5347 12.9973 2.09466 -4227 6 27.6566 39.1405 4.67566 -15.1179 -12.1251 22.0677 -4228 4 26.8424 38.6352 4.89635 10.0979 9.09612 -9.05456 -4229 4 28.2356 39.0161 5.44259 -0.0995191 -2.46215 -4.35417 -4230 6 44.4488 15.8848 30.3925 -17.4686 4.63448 -32.2897 -4231 4 43.6243 16.41 30.3099 13.0937 -10.0294 9.08699 -4232 4 44.649 15.6212 29.457 1.77951 4.94888 23.2191 -4233 6 27.3024 38.1054 13.0907 0.224949 -17.5042 -4.12929 -4234 4 27.6483 37.328 12.5833 -5.61487 10.2238 13.6353 -4235 4 27.1416 37.8221 14.0243 3.20236 0.189733 -16.1751 -4236 6 26.6663 32.9851 36.8362 -23.8807 -10.2072 10.655 -4237 4 27.4028 33.4987 36.5569 24.2269 11.6336 -10.1628 -4238 4 26.2735 33.5165 37.5295 -1.35435 2.25064 8.62378 -4239 6 26.3226 28.1988 31.7158 32.4613 11.5871 5.04411 -4240 4 26.7492 28.3346 30.8217 -6.54697 -0.873531 32.5908 -4241 4 26.9302 28.5068 32.4691 -17.7353 -8.90623 -33.5497 -4242 6 49.2114 35.7792 23.3295 1.46842 19.8344 9.76806 -4243 4 49.8184 36.2235 23.9243 -3.28067 3.63886 4.6357 -4244 4 49.746 35.0988 22.9506 10.5329 -22.9043 -16.5919 -4245 6 44.2369 15.3613 33.5367 -0.695853 -9.37614 14.4104 -4246 4 44.9539 15.1613 32.9326 3.59625 1.2978 -8.28609 -4247 4 43.6189 15.9562 33.0977 0.720121 5.36694 -8.04858 -4248 6 16.6517 35.2697 14.032 -14.9609 -5.91625 -15.8105 -4249 4 16.8478 36.086 14.4923 5.97715 10.4369 8.21626 -4250 4 15.7311 35.3947 13.7134 15.021 -1.16653 5.16189 -4251 6 45.2991 21.4701 12.0564 -47.5016 11.1637 19.3857 -4252 4 45.9844 21.105 11.5386 20.9258 -26.0087 -22.2564 -4253 4 44.5936 20.7913 12.2178 25.8967 12.3347 -6.55717 -4254 6 51.6438 5.33792 20.1099 7.42219 12.4384 36.9688 -4255 4 51.7517 5.79258 20.9932 -2.42789 -17.2577 -23.3969 -4256 4 50.9203 5.81642 19.7 -6.55397 4.36408 -6.3714 -4257 6 22.6153 27.305 0.955308 -12.5158 1.22245 6.52354 -4258 4 21.8819 27.8542 1.31405 9.62632 -7.19502 -8.89748 -4259 4 23.0385 27.8458 0.276527 0.370713 4.24399 -0.0338259 -4260 6 46.8868 12.1467 22.3289 10.3551 9.03073 -1.70047 -4261 4 46.473 12.5446 21.5671 -2.12653 7.07083 -14.4911 -4262 4 46.1639 11.6922 22.7348 -15.0603 -15.1984 17.3736 -4263 6 33.7555 5.60359 25.2366 8.41588 -11.9289 0.48427 -4264 4 34.4013 5.10188 24.7086 -2.4022 4.68399 3.96997 -4265 4 33.0757 5.86414 24.6127 -5.93503 4.46215 -0.558809 -4266 6 44.2476 18.1243 27.2334 30.0322 17.9475 -5.65933 -4267 4 44.0927 18.7931 26.5253 0.465456 -9.97561 17.2792 -4268 4 45.207 18.2464 27.4768 -29.0014 -6.50023 -5.41996 -4269 6 5.27814 37.006 29.0846 -42.995 37.8911 -11.235 -4270 4 4.83357 37.8684 28.7516 22.264 -36.721 16.075 -4271 4 6.19253 37.2033 29.2507 20.6764 5.54169 3.86921 -4272 6 20.033 5.01392 38.9409 6.34377 -32.2179 -4.45843 -4273 4 19.8009 5.56625 39.6765 -4.47316 13.7366 14.9565 -4274 4 20.2948 4.14306 39.3359 -6.8578 18.535 -7.22498 -4275 6 17.9112 2.77214 33.8677 -16.6976 6.01838 23.4157 -4276 4 18.6113 3.34266 33.5322 6.18073 5.31505 -2.96417 -4277 4 17.3526 3.28629 34.5246 17.6921 -17.568 -20.3177 -4278 6 5.56788 23.3774 22.3326 -7.55986 13.5725 18.1102 -4279 4 6.25354 23.3408 21.6412 1.32241 8.57002 8.68476 -4280 4 5.72116 24.1623 22.9232 3.31135 -14.4794 -19.5174 -4281 6 12.7438 28.0244 40.0809 14.6998 26.4392 -25.8726 -4282 4 12.8099 29.0023 40.1455 -0.120572 -14.3051 2.54846 -4283 4 13.1526 27.8611 39.1965 -9.74214 -4.86635 20.6942 -4284 6 50.5283 38.8014 28.4207 -10.7676 14.1923 -1.71082 -4285 4 51.0354 39.5212 28.0559 20.7423 0.788408 -10.014 -4286 4 49.7626 39.3052 28.7255 -7.2831 -13.6434 5.52883 -4287 6 33.5501 8.21498 17.8605 -32.9279 -35.4008 39.405 -4288 4 33.9027 8.87262 17.3189 24.9798 40.0041 -36.6225 -4289 4 33.9074 7.37462 17.5752 8.43731 -7.27798 -4.46199 -4290 6 34.6457 34.7004 17.7764 -12.4293 -15.9601 -10.9704 -4291 4 35.1223 35.3606 18.2944 6.48769 -0.751965 0.253856 -4292 4 35.2388 33.9528 17.5616 -1.14344 9.31979 5.2604 -4293 6 40.7233 5.29016 23.4005 8.26322 -6.33781 10.3585 -4294 4 41.4774 4.87923 23.8731 -9.49225 7.91527 -13.3731 -4295 4 40.0307 4.6112 23.3711 2.34129 5.18948 -0.0201455 -4296 6 16.9127 27.7621 14.4682 52.6044 -4.68653 -2.89351 -4297 4 16.0711 28.1345 14.4444 -59.8378 16.6137 -1.60006 -4298 4 17.4608 28.5627 14.561 1.7801 -9.46587 0.070581 -4299 6 29.0363 14.6633 5.00698 9.76413 -9.29226 13.7719 -4300 4 29.5096 13.8001 4.93115 -9.10936 16.1071 1.03458 -4301 4 28.802 14.7746 5.95339 2.50956 -1.40994 -14.9204 -4302 6 36.8445 17.7203 5.07362 13.6951 -24.032 -28.6565 -4303 4 36.3003 18.4061 5.45056 -9.17068 14.5835 0.43155 -4304 4 36.9783 17.8862 4.10178 -4.81067 2.65881 25.6667 -4305 6 27.7152 25.5071 34.8558 20.6182 -10.3116 10.9196 -4306 4 28.4128 25.1948 35.4689 -8.51497 -1.72528 -14.7569 -4307 4 27.3626 26.2325 35.3632 -10.8781 12.0961 2.58089 -4308 6 24.7577 17.2803 18.064 -3.70908 -2.75228 5.17573 -4309 4 25.2464 17.9619 18.5343 4.21458 5.85634 1.04617 -4310 4 24.0216 17.073 18.6635 3.98676 -0.349172 -5.54229 -4311 6 30.1887 1.57939 5.82314 -15.3902 21.7461 -57.8894 -4312 4 29.5204 1.81013 6.46928 0.301846 -2.58557 7.21893 -4313 4 29.8355 2.03332 4.95505 20.4457 -28.7719 49.9963 -4314 6 37.4518 25.9014 8.44867 -40.4019 -33.5071 29.4213 -4315 4 38.3881 25.8301 8.67833 5.27698 -2.9507 2.74989 -4316 4 36.9261 25.2192 9.0364 31.48 35.4073 -33.2345 -4317 6 24.7717 7.01585 2.25321 22.1725 6.13312 -2.42992 -4318 4 25.3573 6.36243 2.67285 -8.4103 6.94319 2.38151 -4319 4 23.8861 6.6751 2.35128 -10.8992 -4.25211 1.65182 -4320 6 25.7992 38.8457 10.7505 7.22571 37.8744 -16.0906 -4321 4 26.2906 38.615 11.5103 14.31 -23.6918 34.358 -4322 4 26.1189 39.766 10.6411 -14.7913 -5.88601 -10.6141 -4323 6 0.557249 13.5851 28.1314 4.10373 25.7622 10.4527 -4324 4 0.335523 12.7734 27.7191 -4.86664 -22.4284 -15.6315 -4325 4 0.332586 13.4422 29.0593 -0.0574933 0.663208 0.855409 -4326 6 20.4027 17.1068 12.0342 -11.148 -26.8285 -23.5414 -4327 4 20.2541 17.2545 12.9674 -4.18463 -1.09026 14.619 -4328 4 19.9228 16.2663 11.7843 12.058 20.2306 8.20324 -4329 6 30.9875 7.38585 16.6706 43.1327 18.1844 -1.13431 -4330 4 31.2844 7.10043 15.7746 -9.95685 2.73348 15.1831 -4331 4 31.8198 7.8213 17.056 -34.7561 -19.1709 -8.28734 -4332 6 10.1956 5.78615 12.1691 19.1166 9.414 40.461 -4333 4 10.1305 6.30649 11.4071 -1.6074 30.0602 -42.5686 -4334 4 9.61456 5.08708 11.9844 -30.6818 -38.1141 -6.43609 -4335 6 18.4382 31.3444 24.1606 1.21336 -6.12525 2.83497 -4336 4 18.3965 30.3858 24.3134 -0.788465 1.61506 0.642095 -4337 4 18.2608 31.7571 25.0112 -0.825834 1.26386 0.0223154 -4338 6 27.8905 29.2615 29.2809 39.8074 15.5588 -29.008 -4339 4 28.4007 29.5348 28.4528 -32.3375 -5.53357 22.8869 -4340 4 28.6323 28.9656 29.8273 -8.8667 -4.73078 13.1255 -4341 6 38.3648 15.4483 29.7818 29.0993 -31.9427 29.9284 -4342 4 38.2401 14.49 30.0972 1.05022 38.774 -16.5136 -4343 4 39.2299 15.7257 30.2111 -34.0699 1.82394 -15.2271 -4344 6 21.7074 34.7851 5.58078 8.19375 -39.9271 5.99876 -4345 4 21.4944 33.8203 5.80476 0.548141 38.153 -5.97617 -4346 4 20.9458 35.3238 5.82701 -5.25279 -7.50871 2.73382 -4347 6 18.2117 16.8293 1.01571 -12.7233 9.06437 9.63769 -4348 4 17.5846 17.1799 0.363518 5.67247 -6.87112 -0.25098 -4349 4 17.8106 17.1001 1.86952 7.78128 -5.5379 -6.7416 -4350 6 43.5131 18.5098 39.3469 22.8992 -24.809 -24.744 -4351 4 42.9473 19.1501 39.756 -14.025 22.4758 -1.21679 -4352 4 43.733 18.7829 38.41 -14.2449 3.90475 27.8798 -4353 6 17.7973 10.0724 35.5497 11.3899 1.25644 -17.5776 -4354 4 17.9076 9.35875 36.1674 -1.9111 -9.85084 12.7139 -4355 4 18.4727 9.8826 34.8661 -11.1758 5.45367 7.50841 -4356 6 36.5836 30.5676 29.0795 -26.735 36.4018 -15.4516 -4357 4 36.5101 31.4618 28.6208 1.83791 -30.0083 14.6126 -4358 4 37.4767 30.2665 28.9506 20.8385 -5.81304 -4.31186 -4359 6 38.5024 35.9654 10.4302 15.5283 7.61871 55.4477 -4360 4 38.713 36.6589 11.1463 -7.3207 -22.805 -33.4203 -4361 4 38.3781 35.1576 10.9824 1.19538 10.4075 -12.7486 -4362 6 43.3976 18.7941 34.3717 -4.38817 -12.2014 30.3889 -4363 4 43.0627 18.1963 33.6763 0.988603 1.53223 14.3474 -4364 4 43.2603 18.4022 35.293 0.0857578 9.32555 -37.8245 -4365 6 11.0576 40.22 6.11206 -6.0837 -9.04747 -4.15047 -4366 4 11.6426 40.8981 6.46389 1.08734 7.77423 2.35531 -4367 4 10.1474 40.5638 6.06331 9.30243 4.06404 0.87098 -4368 6 48.3282 13.7431 24.4718 -8.87905 25.3224 16.0087 -4369 4 47.8536 13.4091 23.7195 -8.5266 -8.47545 -16.9724 -4370 4 47.8942 14.6072 24.6749 14.3726 -19.4181 -2.72093 -4371 6 1.47819 25.7805 23.7819 -0.0731812 -13.4431 -3.72387 -4372 4 0.822875 26.4404 23.4927 11.4147 5.84295 7.97453 -4373 4 2.19403 26.202 24.2849 -5.19934 9.21725 -1.17005 -4374 6 20.5754 0.0393205 21.1081 25.6075 5.05031 -17.3956 -4375 4 19.8484 0.361847 21.622 -17.4675 -5.38456 12.9096 -4376 4 20.5586 40.9849 21.0455 -11.1839 1.66381 7.6849 -4377 6 37.6642 12.8991 30.7037 -9.9457 -20.8438 -29.8221 -4378 4 37.1371 12.462 29.9889 18.2914 6.1257 8.16018 -4379 4 36.9745 13.1334 31.2979 -14.5618 11.4049 21.409 -4380 6 49.47 17.3794 9.25364 5.30826 8.19981 -9.14457 -4381 4 48.5231 17.6061 9.31556 15.6584 -1.48937 -5.70503 -4382 4 49.8852 17.9254 8.53549 -14.9109 -12.0851 17.4703 -4383 6 34.3662 5.35535 17.144 13.1974 2.57034 -29.0571 -4384 4 34.5198 5.2998 16.166 0.54303 4.43319 20.4174 -4385 4 33.4623 5.07036 17.243 -16.3394 -6.24992 8.38082 -4386 6 14.7833 27.6665 0.0728061 -6.74966 -7.64198 -7.69033 -4387 4 13.9925 27.8402 41.4242 12.1928 3.48747 9.75107 -4388 4 15.1668 28.5017 0.401621 -7.96817 -0.0208253 -5.02821 -4389 6 48.8656 15.5206 20.7458 -9.86138 0.136748 20.6241 -4390 4 49.0651 16.3952 20.4263 0.209458 6.72405 -7.85333 -4391 4 49.1204 14.8922 20.0789 6.79298 -9.16117 -16.8166 -4392 6 23.807 40.3882 20.3905 -3.398 23.5063 24.1729 -4393 4 23.5208 41.0259 21.1064 9.42377 -19.8715 -22.5683 -4394 4 24.7282 40.1652 20.6096 -6.91059 4.34471 -3.10789 -4395 6 35.1847 31.5046 13.7021 -31.0181 23.9456 -35.1619 -4396 4 34.2309 31.3725 13.4471 24.927 2.88592 7.27171 -4397 4 35.3946 30.8036 14.2945 4.95161 -20.634 19.3451 -4398 6 10.9658 9.01332 39.5058 -15.2714 21.9147 -18.395 -4399 4 10.5965 9.92979 39.4 9.97221 -25.6919 2.69722 -4400 4 11.1763 8.90125 40.4322 -2.36933 4.41176 3.08643 -4401 6 53.2091 4.88966 16.6226 -14.1926 -12.3632 -40.3028 -4402 4 53.7513 5.3458 17.242 7.58091 5.46958 35.753 -4403 4 52.4727 4.38631 17.0042 6.19997 4.37068 9.30068 -4404 6 7.84194 33.803 26.1542 28.433 15.6582 -32.2535 -4405 4 7.6241 34.0763 27.0539 6.31302 8.01731 -0.629847 -4406 4 8.43319 34.4994 25.6777 -29.4311 -29.3345 32.8186 -4407 6 31.3263 27.9445 6.27534 4.23256 -31.0286 -11.1959 -4408 4 31.9071 27.4889 6.92578 -8.71467 11.4818 -6.48617 -4409 4 31.157 27.2952 5.54778 3.06851 13.2477 11.4148 -4410 6 31.3665 2.16522 41.0549 8.67281 8.84877 18.675 -4411 4 31.764 2.22522 0.0553479 -13.0589 -8.62932 -24.7178 -4412 4 31.1679 1.24258 40.8683 -0.324156 -6.15668 4.61941 -4413 6 33.7659 4.25511 35.8987 -17.0312 -3.82062 1.06926 -4414 4 34.343 3.86214 36.5812 -9.75418 2.24627 -3.55813 -4415 4 32.8029 4.08293 36.1352 33.1171 1.27305 -1.46623 -4416 6 47.9658 16.0637 29.8469 2.67107 -7.93457 21.4822 -4417 4 48.7643 16.2814 30.3583 0.589987 0.219824 -12.8585 -4418 4 47.4335 15.6159 30.5321 -1.60863 4.8928 -15.0046 -4419 6 49.3312 10.0914 28.5924 -0.28152 -2.80953 -5.35856 -4420 4 48.5695 10.6519 28.8218 4.15282 -2.34898 -5.74021 -4421 4 49.4995 10.1231 27.6243 -2.44246 2.9592 14.5426 -4422 6 21.4058 27.7857 29.7524 8.26148 -8.5709 13.934 -4423 4 21.8935 27.2574 30.4222 -7.07544 0.199766 -18.4014 -4424 4 21.2999 28.6278 30.1835 -3.48366 18.9655 1.67033 -4425 6 11.6744 39.4982 25.8468 7.90293 7.18169 -2.58674 -4426 4 12.2285 38.7361 26.0681 1.40058 3.92388 1.36909 -4427 4 10.8023 39.1241 25.7384 -12.6269 0.672841 -0.990747 -4428 6 22.9696 39.3076 7.85132 -6.07512 -3.4122 -1.68244 -4429 4 22.2682 38.6524 7.98148 0.173976 5.86283 1.52023 -4430 4 22.7132 40.0561 8.41581 1.67877 -3.24138 -2.90234 -4431 6 42.551 35.9177 31.3369 11.821 -63.1978 11.5341 -4432 4 42.5803 35.466 30.4647 -4.4966 22.226 11.3725 -4433 4 42.4036 36.8376 31.2573 -6.84366 36.9754 -14.9488 -4434 6 33.6582 14.7374 3.97797 20.0935 -7.17859 -40.4554 -4435 4 32.8645 15.2412 4.10613 -20.5582 11.3796 6.05129 -4436 4 33.8494 14.8388 2.99484 -4.26498 -3.76663 30.6135 -4437 6 36.6985 8.59579 17.521 17.5186 -20.4505 -17.8166 -4438 4 37.2174 8.05238 16.87 -10.1577 15.2162 18.3492 -4439 4 36.2061 9.2161 16.9727 -6.85471 3.87096 1.58869 -4440 6 20.8134 32.4132 17.3224 -0.15138 -19.2041 8.32641 -4441 4 20.2101 33.0681 16.9297 -8.31182 -6.81981 10.9196 -4442 4 20.3788 31.7527 17.9441 5.10322 26.2393 -19.6477 -4443 6 20.7088 35.3183 14.0957 -11.7768 -25.3725 -13.8548 -4444 4 21.261 35.5893 13.3574 6.77827 9.37653 -4.07387 -4445 4 20.8679 35.9028 14.8214 6.04206 13.2639 9.85712 -4446 6 20.2377 2.51389 40.1721 -7.12285 -8.41588 24.6249 -4447 4 19.7963 2.31331 41.0421 14.3479 1.04867 -24.2175 -4448 4 20.7189 1.71371 39.9103 -4.456 1.41042 1.49289 -4449 6 15.0332 14.4679 0.20602 13.2809 -6.14192 -34.7112 -4450 4 15.5535 13.6508 41.8516 -13.9549 30.8146 5.37449 -4451 4 15.3124 15.2392 41.5458 -1.11857 -25.4589 11.3055 -4452 6 24.8198 37.3334 18.5262 -9.71694 12.1129 21.4379 -4453 4 24.5044 38.0178 17.9266 6.55828 0.975012 -4.85481 -4454 4 24.4839 37.6255 19.4009 7.37292 -12.3795 -13.3571 -4455 6 3.16023 27.7824 5.25746 -7.59771 -9.49442 8.09122 -4456 4 2.57386 27.9573 6.05068 26.7372 -11.3185 -11.6141 -4457 4 4.04718 27.3724 5.4685 -26.4098 5.90831 3.92345 -4458 6 37.1274 39.059 36.0582 -20.0626 39.3499 3.12364 -4459 4 37.4397 39.697 36.7497 0.155645 -22.9334 -11.3782 -4460 4 37.5741 38.2261 36.1006 18.9616 -13.4483 8.05827 -4461 6 41.3496 16.372 3.85306 -8.55617 -26.9153 -3.74777 -4462 4 41.2863 17.3336 3.84263 10.0449 1.9656 13.5452 -4463 4 42.0245 15.9886 4.46176 -7.16622 24.1057 -6.4954 -4464 6 15.5715 3.1806 35.3543 4.49903 -8.79025 -44.1337 -4465 4 15.0747 3.51322 34.5661 7.45265 -4.29831 20.3405 -4466 4 15.2394 3.62675 36.1076 -11.9729 17.6287 21.2524 -4467 6 33.1697 24.252 7.98021 17.4163 -35.2043 24.5175 -4468 4 33.373 24.4892 7.07941 -5.88693 14.0606 -13.9779 -4469 4 32.5854 24.8767 8.38373 -10.6809 23.5743 -3.02942 -4470 6 35.8792 29.7453 15.5891 -14.351 2.75051 -7.10357 -4471 4 36.7674 29.6271 15.8378 44.9858 5.9786 2.16229 -4472 4 35.4705 29.0828 16.1298 -19.5083 -3.35284 8.18061 -4473 6 17.5951 36.8258 41.8642 -13.8657 0.640745 -39.4401 -4474 4 18.0986 36.7885 0.752491 19.5286 0.61142 14.8967 -4475 4 18.204 36.9888 41.0995 -4.16013 -2.78766 23.3657 -4476 6 26.5622 4.14757 31.1303 -11.2209 -47.8968 -15.8259 -4477 4 27.2883 4.63526 31.456 28.856 27.2634 11.544 -4478 4 26.9475 3.23966 30.9928 -12.9924 23.1667 5.46977 -4479 6 31.9456 1.33308 34.4467 -12.9904 6.64728 -11.4505 -4480 4 32.8071 1.19449 34.8725 -11.0783 -3.65615 8.33208 -4481 4 31.1956 1.0725 35.0172 18.2758 0.413953 2.527 -4482 6 24.503 14.7492 2.38048 9.24208 -0.0712211 -0.802907 -4483 4 24.1928 14.0003 2.93847 14.4388 11.7071 -7.35684 -4484 4 25.4689 14.9243 2.53228 -19.8697 -9.93034 3.69906 -4485 6 25.7634 20.9148 27.525 0.946636 -0.977661 -1.30084 -4486 4 25.4997 20.5428 28.395 3.38508 9.32598 -11.7317 -4487 4 25.6529 21.8806 27.5755 0.284497 -3.23384 4.14496 -4488 6 18.1477 40.1511 30.6505 2.638 -12.7558 5.82509 -4489 4 18.5379 39.2542 30.773 0.361891 20.0487 -3.45439 -4490 4 18.8736 40.7943 30.5754 -0.793328 -5.73314 0.616918 -4491 6 46.8137 23.9108 24.5765 -6.45001 25.2139 -38.2053 -4492 4 46.156 24.4917 24.0674 25.2521 -23.4518 17.6745 -4493 4 47.3533 23.4819 23.8873 -7.92808 3.44465 4.72259 -4494 6 45.5993 22.6806 26.5072 -4.87261 3.12825 -8.14378 -4495 4 46.0946 22.9584 25.7273 -3.42504 -3.72677 5.16847 -4496 4 46.0209 23.1613 27.2227 -5.79148 -3.32105 5.25932 -4497 6 20.0977 4.47574 26.7104 -1.85738 36.2438 14.3308 -4498 4 20.3766 5.37803 26.4593 -10.8474 -9.08605 12.6513 -4499 4 20.6066 3.98633 26.1049 14.7704 -34.5311 -24.6657 -4500 6 35.268 26.6035 12.5547 25.3434 4.5593 25.1203 -4501 4 35.7054 25.7374 12.5354 -13.4481 2.49909 -6.64065 -4502 4 35.8431 27.0669 13.1929 -15.092 1.56141 -12.9558 -4503 6 3.25549 33.9664 12.2985 -21.2488 -6.99508 3.93395 -4504 4 2.30606 33.7392 12.3085 7.5225 -4.25393 -1.25154 -4505 4 3.25844 34.917 12.332 8.53638 16.5693 1.24934 -4506 6 36.6808 1.27299 25.5856 -28.051 -2.86161 17.5249 -4507 4 37.6164 1.46673 25.6835 8.21338 5.71919 3.59986 -4508 4 36.1703 1.6124 26.3685 15.6278 -2.9361 -18.4357 -4509 6 16.8737 4.664 24.0353 -31.9925 -2.01789 -27.2632 -4510 4 15.8786 4.73848 23.8401 40.5517 -2.65221 8.73903 -4511 4 17.2589 4.19458 23.2519 -3.48506 7.68373 17.7614 -4512 6 39.6701 15.0742 7.83356 -1.71206 -7.05123 2.14494 -4513 4 39.2725 14.2274 8.02711 2.44544 -9.24519 17.4119 -4514 4 39.3892 15.1326 6.9218 7.69265 14.011 -7.76766 -4515 6 9.96731 20.1909 2.92864 -13.1382 1.0323 -16.144 -4516 4 9.71565 20.5309 2.05786 3.65664 7.03968 6.64426 -4517 4 9.8995 19.2377 2.78093 4.24026 5.10291 12.3576 -4518 6 23.4077 4.6159 15.27 -3.48308 -16.1533 -1.5067 -4519 4 23.619 4.71624 14.3536 6.29203 -7.01184 -22.1313 -4520 4 23.1672 5.50294 15.4683 -4.33935 19.8524 20.6561 -4521 6 23.5267 41.6518 17.9122 -9.44104 0.807914 21.3506 -4522 4 23.7067 41.2659 18.7956 7.59245 -0.294373 -11.029 -4523 4 22.6339 0.0834245 18.0732 1.82991 3.48892 -13.1537 -4524 6 30.9316 4.82324 1.33107 45.9774 51.3713 7.99935 -4525 4 30.5768 4.02682 1.05687 -28.0042 -54.4029 -17.3695 -4526 4 31.8094 4.8761 0.879215 -15.6392 -0.833181 8.5221 -4527 6 29.2201 33.7587 18.5991 58.073 2.92721 -1.85527 -4528 4 30.1837 34.1183 18.6008 -42.2538 -17.2347 0.0641557 -4529 4 28.6837 34.5413 18.5643 -15.6262 17.5996 3.33909 -4530 6 23.1221 16.7099 3.68521 11.8431 -16.3115 0.0733348 -4531 4 23.6562 16.338 2.95547 -9.45134 2.67217 9.8165 -4532 4 23.048 17.6538 3.54099 -2.31098 6.59774 -1.54538 -4533 6 34.8961 26.7639 31.7325 -1.99602 4.46994 3.67284 -4534 4 35.0929 27.7139 31.562 -2.18198 -17.8875 -5.58085 -4535 4 35.0252 26.2302 30.9312 2.47742 18.1005 -1.54363 -4536 6 7.11189 40.7663 20.959 14.901 4.90705 15.7674 -4537 4 6.49418 40.4573 20.3006 -5.17655 -2.88906 -15.6427 -4538 4 7.9749 40.9101 20.5297 -6.61986 -3.78335 -7.15935 -4539 6 52.4451 9.69387 11.9379 -8.46192 -13.0679 -16.1645 -4540 4 52.1167 8.90553 11.4509 5.46474 18.3719 13.4625 -4541 4 53.1134 10.0871 11.3593 -6.16158 -0.354597 4.80602 -4542 6 12.0344 32.7576 27.7445 1.28323 7.36678 12.5499 -4543 4 11.2848 32.2741 27.3627 7.37999 2.33687 -5.47139 -4544 4 12.7987 32.654 27.1746 -1.40521 -5.62475 -4.84597 -4545 6 15.7821 18.5441 0.84801 8.76354 -4.35468 -11.8188 -4546 4 16.4439 18.9467 1.42581 -3.0166 1.81121 1.10538 -4547 4 14.9492 18.5892 1.29924 -12.8156 0.756803 9.02992 -4548 6 30.9925 13.9418 7.42386 -4.40747 -9.92517 -19.1249 -4549 4 31.0137 13.4754 6.53341 6.38174 17.9129 28.0089 -4550 4 31.6996 14.6103 7.52177 -5.32565 -11.3142 -7.68087 -4551 6 23.9405 39.5605 3.5435 10.8606 -6.43074 -8.73391 -4552 4 24.3095 38.7805 4.04208 -2.00396 18.4511 -18.0645 -4553 4 24.6123 39.8651 2.88148 -9.69774 -9.50421 15.8523 -4554 6 53.2462 13.9551 2.00337 -15.5118 -12.0942 -3.71099 -4555 4 54.104 14.269 2.28215 12.5804 5.35006 1.30654 -4556 4 53.0522 14.3304 1.13281 7.32968 -0.777694 2.32044 -4557 6 29.4483 26.4268 7.81741 -0.171572 11.4439 -18.4732 -4558 4 29.8672 26.7876 7.00927 -3.33338 -4.99995 18.6366 -4559 4 28.5088 26.3872 7.58736 -4.03891 -2.78124 5.15679 -4560 6 24.6251 23.6043 31.0935 -26.8137 17.7603 -44.4691 -4561 4 23.7139 23.2229 30.9355 29.773 11.0738 8.78977 -4562 4 24.7983 24.2076 30.2965 -2.98074 -30.8217 36.523 -4563 6 33.658 19.3188 40.511 -4.29932 4.0975 7.85681 -4564 4 33.8365 18.6271 41.1728 0.0947513 0.993086 -5.72158 -4565 4 34.3002 19.2334 39.7953 0.390848 -1.03282 -3.03706 -4566 6 0.558986 35.9852 14.2205 11.1667 11.0015 21.0521 -4567 4 1.21386 36.1432 14.9149 3.92292 -5.96876 -2.97707 -4568 4 0.043734 36.7876 14.3014 -15.3768 6.08493 -10.5247 -4569 6 7.05222 12.7587 15.7802 -26.1824 -15.4106 14.8382 -4570 4 6.35773 12.5373 16.4499 19.2033 7.53925 -13.5919 -4571 4 6.88557 12.0803 15.1093 4.12905 5.75416 0.888 -4572 6 7.8802 3.87979 22.4264 4.564 -30.6165 13.1651 -4573 4 7.61737 4.55637 21.8154 -5.12813 13.4305 -13.5146 -4574 4 7.59435 3.01808 22.0419 3.92228 16.9329 8.71162 -4575 6 50.747 32.0919 16.246 0.584829 29.9532 -6.88448 -4576 4 49.8575 31.8158 16.477 -3.66132 0.0213613 -0.234359 -4577 4 50.6533 33.048 15.9617 2.92819 -31.696 10.1835 -4578 6 15.3083 18.2099 30.0577 17.4273 -12.3999 25.5818 -4579 4 14.8795 18.523 29.2753 -13.2188 2.60124 -19.4058 -4580 4 14.9888 17.3027 30.2404 2.47215 8.3937 -6.40515 -4581 6 36.7253 25.4508 33.3862 -30.1432 30.6395 -17.6873 -4582 4 35.9871 25.9696 32.8546 42.334 -36.2451 27.5582 -4583 4 36.7428 24.5171 33.143 -7.68133 1.91065 -3.3758 -4584 6 16.5208 21.8449 20.262 -11.2097 8.64672 -3.63533 -4585 4 16.6085 20.9267 19.9682 1.68058 -0.497742 -2.90804 -4586 4 16.3112 22.3946 19.4823 4.36577 -8.59001 6.07269 -4587 6 44.2833 3.11948 30.0766 -7.99673 -6.73576 30.9987 -4588 4 44.2005 2.2232 29.7402 -0.794022 -7.70278 -4.62871 -4589 4 44.5183 3.67066 29.3503 7.77568 15.2131 -24.9404 -4590 6 51.0808 14.1269 27.7758 -27.047 -14.2895 -4.28411 -4591 4 51.175 15.071 27.7901 8.66575 19.7266 0.878182 -4592 4 50.1173 14.0309 27.5969 15.0189 -4.76366 3.10402 -4593 6 54.1497 15.8755 27.1203 10.9044 -5.07506 15.753 -4594 4 54.6247 15.0341 27.411 -19.35 18.5916 -21.6107 -4595 4 53.6213 15.8397 26.2863 11.6919 -13.2292 13.7718 -4596 6 26.7269 15.1716 34.5247 3.07047 6.28357 -2.56105 -4597 4 26.6547 16.15 34.5201 9.87746 -16.6036 -4.19036 -4598 4 27.4477 14.9176 33.917 -5.54963 13.4877 1.89491 -4599 6 34.6713 2.21044 27.481 35.3652 -9.42756 14.1603 -4600 4 34.3712 2.0217 28.3795 -9.10436 3.38048 -0.887416 -4601 4 33.9282 2.37922 26.9258 -24.4077 6.67858 -6.22498 -4602 6 36.3012 17.6491 40.388 5.86113 23.4658 6.44349 -4603 4 35.7206 17.1804 39.7974 -3.43874 -12.7236 -2.47465 -4604 4 36.6864 17.0408 41.0377 -6.22241 -0.114851 -7.42509 -4605 6 26.2819 0.194243 33.0916 -21.1162 -1.74839 5.89968 -4606 4 26.0541 0.792538 33.818 7.17118 8.51167 2.05738 -4607 4 25.4361 41.6393 33.0097 0.772233 -7.73624 -3.23605 -4608 6 5.19547 35.5715 31.6247 14.6733 -21.492 26.4929 -4609 4 6.10271 35.831 31.8735 -9.75028 2.17691 -1.53344 -4610 4 4.97694 36.0548 30.8519 -3.41417 18.4244 -29.6169 -4611 6 20.2195 22.0294 35.119 8.25657 -3.203 11.321 -4612 4 19.9286 21.1888 34.7559 -2.68712 -4.78598 1.15285 -4613 4 20.5567 21.7901 36.0152 -5.29706 4.10974 -20.8318 -4614 6 15.9087 36.5843 36.9399 0.69981 -30.9087 31.3945 -4615 4 16.5764 37.2836 37.0377 -3.33596 -3.14632 -1.27145 -4616 4 16.032 35.9777 37.754 -5.87689 21.7482 -34.0408 -4617 6 30.95 22.3912 3.57027 12.227 -51.3484 -20.5494 -4618 4 31.0645 22.6091 4.4902 1.82476 2.59415 19.1922 -4619 4 31.2691 21.4218 3.50648 -13.7255 40.3499 2.75328 -4620 6 47.0405 8.41049 14.2025 -7.26712 -13.7585 -23.7685 -4621 4 46.2225 8.31623 13.6472 18.9804 2.55096 13.7682 -4622 4 47.7321 7.85584 13.7597 -18.0416 11.4216 8.02226 -4623 6 34.1106 18.627 3.15563 -0.4946 23.1394 22.2065 -4624 4 34.672 18.2914 3.86301 0.996255 -3.71784 -4.49801 -4625 4 34.2399 18.1173 2.36738 0.542984 -13.2578 -17.3669 -4626 6 26.7976 25.3916 12.343 -23.6037 -44.5624 17.4882 -4627 4 27.2059 26.2338 12.4335 13.1462 29.8808 4.32264 -4628 4 26.6887 24.995 13.243 7.37483 11.5945 -21.6739 -4629 6 22.6215 25.7777 30.8835 17.9212 -8.3502 11.6983 -4630 4 23.3826 25.7056 31.4928 -6.70991 6.16838 -4.71983 -4631 4 22.2455 24.8881 30.8847 -4.10822 -0.13742 -3.2228 -4632 6 23.6315 9.78689 35.7599 5.48292 -2.30097 -0.625566 -4633 4 22.8113 10.2893 35.7248 -4.77612 1.7474 -0.383276 -4634 4 23.3643 8.87406 35.5171 2.31753 16.9109 3.97959 -4635 6 10.4044 36.7742 9.63922 -25.0741 -4.1625 3.51028 -4636 4 9.48479 36.4361 9.55892 17.1497 7.1291 1.06445 -4637 4 10.7029 36.9295 8.73946 3.49181 4.27039 -8.54773 -4638 6 4.00239 32.4234 25.8687 17.3833 10.7639 11.9139 -4639 4 4.35688 32.9952 25.1699 -1.7627 -0.965582 -1.95819 -4640 4 3.3252 31.8731 25.4905 -12.2764 -14.2405 -10.2138 -4641 6 29.0717 26.0252 18.6551 27.2015 -27.7815 2.54409 -4642 4 28.1485 25.9947 18.9226 -9.28828 -8.18845 2.68073 -4643 4 29.5616 25.1801 18.9271 -24.0321 31.3207 -7.4501 -4644 6 15.3034 1.33037 27.9713 -8.15532 13.2931 -1.88459 -4645 4 14.9824 0.900448 27.1643 -4.10476 8.37726 9.18093 -4646 4 14.8435 2.19317 28.1161 8.64797 -17.4448 -9.70896 -4647 6 48.6122 2.88813 22.9601 -14.0575 20.6462 10.9468 -4648 4 48.3097 2.01316 22.7294 4.97712 -8.72373 -1.92059 -4649 4 49.4728 3.0448 22.5739 5.56154 -9.57595 -10.4155 -4650 6 53.0134 0.348391 19.7218 2.72624 -2.60203 -3.14968 -4651 4 52.5877 42.0257 20.5538 -0.625041 0.289898 3.74318 -4652 4 52.305 0.305612 19.0628 -0.905041 -0.864478 -1.55308 -4653 6 1.39118 17.4858 17.9447 -8.50794 14.6458 12.7327 -4654 4 1.24353 17.4779 16.9894 -1.31782 -10.0732 -1.96873 -4655 4 1.47925 16.6123 18.3551 -1.8326 -9.29856 -10.4725 -4656 6 37.8975 19.0277 37.6053 -28.6618 15.029 -11.7184 -4657 4 36.9647 18.7897 37.7838 11.6122 1.96204 1.16191 -4658 4 38.4406 18.4447 38.1174 10.3965 -16.3488 12.6679 -4659 6 26.9855 30.3558 38.071 9.50079 1.40194 -4.36533 -4660 4 26.0886 30.216 37.7369 5.39533 7.19535 -1.12484 -4661 4 27.2954 31.2276 37.7499 -13.0308 -11.5285 -0.168161 -4662 6 20.0885 18.5747 3.04679 -6.02291 21.5949 -15.2672 -4663 4 19.9787 17.7407 3.50085 7.53739 -11.7285 12.3408 -4664 4 20.8981 19.0299 3.33477 -4.38138 -14.9723 0.744253 -4665 6 35.0861 6.94018 4.08702 3.04221 -3.62035 -0.583554 -4666 4 35.6351 7.18342 3.33325 6.4301 -2.1748 -2.62446 -4667 4 34.2564 7.39563 3.93984 -10.6534 0.652929 2.2495 -4668 6 22.2213 37.08 31.2556 -28.1532 13.1327 42.6182 -4669 4 22.1563 36.8958 30.3458 -2.68084 -5.78815 -35.014 -4670 4 21.2899 37.3194 31.5407 35.2494 -6.03647 -12.8067 -4671 6 12.3954 22.364 41.8234 21.4337 26.9075 -8.21443 -4672 4 12.9612 23.1595 41.5956 -22.2624 -27.6618 12.5485 -4673 4 11.7092 22.295 41.1522 0.74395 2.83494 0.343647 -4674 6 43.2331 30.3213 23.157 26.8689 32.5799 1.85734 -4675 4 44.1495 30.0558 22.8796 -21.7207 5.89602 6.32158 -4676 4 43.3514 31.2801 23.4416 -6.45211 -30.9956 -6.78246 -4677 6 16.5257 8.07813 16.6617 -19.4309 -12.5216 11.6481 -4678 4 16.3886 8.34983 15.7476 7.00958 2.01583 -5.14722 -4679 4 17.4107 8.32004 16.9428 8.9294 8.4681 -2.86418 -4680 6 10.0506 8.65043 31.7756 -2.39508 10.2278 -10.4865 -4681 4 10.14 7.97578 32.4103 1.95442 -36.8206 12.1998 -4682 4 10.116 9.39125 32.3649 -0.107045 27.388 0.472024 -4683 6 10.1509 6.49695 25.6483 14.6726 -6.33183 2.00995 -4684 4 9.37694 6.15153 26.0805 -12.3653 -8.75157 5.1154 -4685 4 9.82248 7.1865 25.0601 3.70088 -0.958502 2.30736 -4686 6 49.8668 7.2369 25.5225 -24.0329 9.97804 -6.35029 -4687 4 50.053 6.31696 25.3599 8.14544 -13.6468 -2.92498 -4688 4 50.6696 7.6642 25.7982 18.0374 4.82749 5.17198 -4689 6 18.4641 37.5693 33.932 -1.74635 9.46172 -1.89257 -4690 4 17.7617 38.2474 34.0853 10.1616 -18.2299 -3.47398 -4691 4 18.0542 36.6946 34.0238 -8.30855 4.53024 1.19921 -4692 6 32.1897 34.7964 39.2558 32.2313 -17.5381 13.0656 -4693 4 32.48 34.3381 40.0896 -7.23509 10.7133 -18.5379 -4694 4 31.2879 35.0284 39.3813 -31.6037 5.0658 8.82 -4695 6 49.5304 23.9104 4.45569 25.8701 3.67026 -38.321 -4696 4 49.7808 23.1947 5.01942 4.2809 -18.8946 17.0996 -4697 4 48.8132 24.3493 4.85794 -31.8244 16.1567 21.064 -4698 6 6.0606 24.4992 33.9345 -0.638471 -2.64646 7.7036 -4699 4 6.7001 23.7849 33.7997 2.17947 5.97399 -8.00372 -4700 4 5.47521 24.1274 34.6146 -0.567039 8.82042 -5.77933 -4701 6 1.71497 22.9937 24.1827 2.23241 21.1509 -1.27791 -4702 4 1.62302 23.9425 23.95 -0.486435 -10.8617 3.92094 -4703 4 0.825214 22.7289 24.4403 -5.44701 -4.12175 2.39318 -4704 6 12.4657 16.5565 32.3481 -44.3953 42.3465 -23.9812 -4705 4 13.2256 16.0186 32.4214 25.6927 -27.9273 24.4997 -4706 4 11.8347 16.6394 33.1026 23.5286 -12.3088 -0.369419 -4707 6 21.3722 37.3857 27.9432 8.33623 1.67622 30.3175 -4708 4 21.2745 37.3852 27.0022 -8.47587 6.30229 -26.1478 -4709 4 20.7646 38.0573 28.2974 0.343549 -1.37388 -6.67046 -4710 6 27.2371 40.835 28.8059 -14.5618 2.70883 26.0148 -4711 4 26.5104 41.4636 28.9519 7.17104 -1.72995 -14.6333 -4712 4 27.2442 40.3637 29.6524 5.83721 -3.62297 -8.28664 -4713 6 0.999535 21.7321 13.5318 -29.3194 4.17708 -0.571391 -4714 4 1.85706 21.6318 13.8745 50.1621 -4.04822 5.83187 -4715 4 0.493313 21.4968 14.3164 -12.4374 2.61082 -2.41507 -4716 6 22.3196 2.57547 8.74609 19.5097 -5.43411 17.7027 -4717 4 22.9517 3.10624 8.26305 13.4452 6.72454 -0.92593 -4718 4 21.5477 2.63817 8.2102 -22.9662 -0.14239 -10.9727 -4719 6 29.9886 17.8486 8.24374 -1.93571 4.49032 -2.67939 -4720 4 29.0601 17.6146 8.32603 -5.42798 -1.41354 1.1127 -4721 4 30.4131 17.4547 9.01282 4.29332 -3.23535 5.29369 -4722 6 3.62824 37.7086 25.7053 -21.3362 8.32154 -6.60892 -4723 4 4.42904 37.184 25.8405 -4.94962 -9.47676 -0.42012 -4724 4 2.83762 37.1591 25.4673 21.6133 3.65171 5.88982 -4725 6 26.7972 27.6476 36.3581 -47.4115 -5.5291 12.7506 -4726 4 26.8465 28.2624 35.6306 8.29087 8.74477 -10.4705 -4727 4 25.8218 27.6191 36.6005 30.1762 -0.597939 -6.56813 -4728 6 13.3509 25.3111 38.1214 6.90903 -15.9492 13.2692 -4729 4 13.3459 24.3911 38.4732 0.919555 17.3618 -5.73458 -4730 4 14.144 25.7168 38.5298 -8.43807 -1.25323 -5.48633 -4731 6 49.7161 27.2636 6.73274 -18.8339 5.2299 -32.7408 -4732 4 49.5935 26.3653 6.40806 5.58405 -0.645115 8.82912 -4733 4 49.2001 27.7791 6.04852 15.3529 -4.94049 26.886 -4734 6 39.7451 11.5811 10.2076 8.75523 -9.51322 -11.6408 -4735 4 40.371 10.9447 9.80262 -5.32314 14.1891 9.76509 -4736 4 39.1233 11.799 9.49079 2.50191 2.43793 7.76023 -4737 6 17.4883 24.9894 35.5591 -19.4762 1.01983 7.35275 -4738 4 17.0975 24.7887 34.694 2.72786 0.423626 1.28381 -4739 4 18.4353 24.8575 35.5073 10.004 -2.92602 -7.93295 -4740 6 45.0832 34.9807 31.8277 24.5651 -3.79623 6.38158 -4741 4 44.3095 35.5111 32.0501 -8.6141 -4.27399 -12.5931 -4742 4 44.9123 34.3632 31.1055 -12.5508 0.508806 -0.453023 -4743 6 30.2187 9.89463 31.3271 7.05348 4.55507 6.68413 -4744 4 30.4541 10.7656 30.9635 -3.12777 -8.04008 8.45875 -4745 4 30.1355 10.0083 32.293 1.90576 1.32601 -8.54322 -4746 6 32.3712 9.2149 6.61373 28.8381 -35.7198 -39.9492 -4747 4 32.1726 8.66567 5.78496 5.01502 20.0116 29.9298 -4748 4 31.5547 9.49954 6.96481 -36.3246 12.521 14.22 -4749 6 9.26959 24.9556 35.9161 1.96832 15.842 -17.2096 -4750 4 8.91298 25.4858 35.1726 -0.127744 -15.1166 11.0351 -4751 4 9.85583 25.5957 36.3463 -2.24606 -10.0757 2.02076 -4752 6 40.3298 1.49261 18.8755 10.6299 1.30292 -21.7 -4753 4 39.6194 1.80532 19.3944 -35.8146 17.5344 12.5449 -4754 4 40.7796 0.936194 19.4956 21.1502 -18.4862 6.40423 -4755 6 5.26901 10.6323 30.4328 -1.07618 -0.575959 25.8078 -4756 4 5.0059 11.4532 29.9824 1.00544 3.53991 6.4134 -4757 4 5.36238 10.8297 31.4225 -4.75078 2.46468 -31.0333 -4758 6 25.6472 11.7043 25.6564 -2.85241 -30.912 5.54365 -4759 4 25.9319 12.4737 26.1319 5.23872 14.1859 6.15637 -4760 4 25.9893 10.9537 26.204 -5.41829 19.961 -14.7301 -4761 6 21.91 20.0664 29.7913 -6.2328 1.4725 0.460556 -4762 4 22.5319 20.0532 30.5545 -13.0709 -9.05965 -9.53591 -4763 4 21.5487 19.1817 29.5606 11.8355 8.09924 7.60661 -4764 6 10.008 19.9919 34.5046 11.2891 -12.0839 -11.2138 -4765 4 9.40296 20.4589 35.0806 -5.60052 -0.834193 8.04722 -4766 4 10.0208 19.0442 34.745 -1.06298 11.667 -2.12072 -4767 6 24.6334 10.3662 12.209 5.25257 18.8662 20.0118 -4768 4 24.6941 9.47775 12.5956 1.57271 8.96717 -2.9517 -4769 4 24.9719 11.0034 12.9045 -11.2568 -27.0384 -15.8586 -4770 6 50.4496 28.283 11.5446 48.5969 7.21476 -25.6728 -4771 4 51.3012 28.7385 11.2434 -32.0883 -19.6524 11.3949 -4772 4 50.1145 28.8771 12.2081 -10.2548 6.02908 11.3498 -4773 6 13.9159 27.6234 25.0588 -25.6331 11.4059 -15.4978 -4774 4 13.5005 28.0493 25.83 5.93925 -3.01588 -8.8098 -4775 4 13.4276 28.0022 24.2718 14.6036 -12.4854 23.8457 -4776 6 46.1589 18.6653 40.4078 -23.2184 -0.389309 -10.7846 -4777 4 45.2349 18.5626 40.0761 15.1795 0.391647 5.46432 -4778 4 46.2048 19.5984 40.6658 -0.558864 -5.77386 -4.91212 -4779 6 32.4746 14.176 27.1227 -16.003 2.1806 5.505 -4780 4 31.9042 13.6172 27.6867 7.52463 5.83279 -7.70325 -4781 4 32.1655 15.0897 27.2802 4.78128 -6.53963 -2.41902 -4782 6 14.0556 36.3553 13.3828 19.8073 6.5728 22.6139 -4783 4 14.1017 37.3298 13.5875 -14.1879 -23.5484 -13.1576 -4784 4 13.3212 36.1206 12.8052 -8.41953 14.8686 -5.40295 -4785 6 1.88392 36.5802 21.9963 -4.52806 -9.18778 1.34501 -4786 4 1.78058 36.5165 22.9531 -3.13652 -1.22736 7.08711 -4787 4 2.81062 36.8013 21.8509 3.08344 1.49572 -0.20158 -4788 6 25.283 31.8665 39.7486 -0.0346121 -4.3463 21.3102 -4789 4 24.9491 32.7147 39.4474 -1.97702 6.83441 1.95234 -4790 4 25.5262 31.9404 40.7015 -5.12155 2.92558 -20.0537 -4791 6 6.47988 22.0137 1.28428 -12.6715 -7.61279 -4.66874 -4792 4 5.53909 21.8738 1.48571 10.6555 3.73696 2.93659 -4793 4 6.5727 22.8978 0.916948 1.0061 5.37498 -0.183021 -4794 6 27.6236 25.0404 4.70626 6.00578 18.2896 15.2827 -4795 4 28.5331 25.4118 4.61276 -17.9968 -6.47987 4.19831 -4796 4 27.2352 25.3966 5.54825 13.7859 -6.49357 -18.8943 -4797 6 21.6401 30.9371 41.2305 6.69834 21.9548 -27.1087 -4798 4 21.276 30.3289 41.855 -17.7491 -18.0709 13.8774 -4799 4 21.0024 31.0127 40.4783 8.64888 -5.56942 17.5854 -4800 6 32.355 18.8729 12.7674 13.4209 4.31066 2.75957 -4801 4 31.3956 18.9706 12.835 4.55688 -5.10905 -10.5867 -4802 4 32.607 18.5493 11.8826 -7.53687 3.28724 6.30822 -4803 6 35.6452 19.4617 21.1556 -9.82604 19.2175 8.60555 -4804 4 35.3405 18.5718 21.3708 -2.26659 -3.59924 -3.4629 -4805 4 34.936 20.0876 21.4701 16.8427 -19.1907 -7.36791 -4806 6 27.6904 17.9595 34.0135 2.51947 12.848 9.8691 -4807 4 28.1207 18.371 33.2456 -3.55582 0.0466306 5.59907 -4808 4 28.0719 18.4525 34.7708 -4.77519 -7.99763 -12.3529 -4809 6 34.1913 39.0308 14.8198 -32.2909 7.81486 42.3772 -4810 4 33.7378 38.3849 14.2709 2.40292 -0.641653 -5.60016 -4811 4 33.4938 39.1934 15.5434 31.6198 -1.67931 -26.5413 -4812 6 28.5078 3.47132 33.888 -4.80695 9.04662 2.15546 -4813 4 27.9441 4.2497 33.8725 -11.1427 -2.20885 -1.07295 -4814 4 29.3801 3.85895 33.8332 18.6007 -6.2612 -1.20104 -4815 6 34.9259 32.1312 6.54177 -41.0464 -12.9808 21.9467 -4816 4 34.0171 32.0297 6.98271 38.7419 4.2921 -24.6555 -4817 4 35.5211 32.1736 7.29951 5.76537 -1.35874 -3.25655 -4818 6 31.8896 6.8799 23.5232 0.89208 3.44668 5.58958 -4819 4 32.4231 6.58347 22.7679 -0.16899 1.4285 3.8543 -4820 4 32.2407 7.75715 23.7826 1.29066 -6.24882 -6.25814 -4821 6 18.8559 1.76458 0.828337 -20.5472 23.3683 -17.7838 -4822 4 18.0266 2.11952 0.42761 13.2396 -12.575 3.84382 -4823 4 19.0445 2.38904 1.53279 3.18086 -1.81057 9.578 -4824 6 26.9929 18.9294 11.856 68.8676 -4.65359 -28.5611 -4825 4 27.3133 19.7685 11.4551 -15.5879 -7.28987 7.59546 -4826 4 26.1136 18.988 12.1267 -55.7646 13.8464 15.3945 -4827 6 43.8351 11.1458 18.4443 23.0031 -19.5153 4.50837 -4828 4 43.638 10.8812 17.5537 -13.1544 4.18059 -17.1583 -4829 4 44.5589 10.5175 18.6246 -1.75483 13.9327 9.72942 -4830 6 33.4946 40.5615 37.6755 15.4013 8.76106 -9.33396 -4831 4 34.0096 40.2689 38.4502 -12.4229 -1.46966 -1.83753 -4832 4 32.5786 40.2698 37.7667 -1.95229 -4.85928 9.55413 -4833 6 15.6186 26.7023 39.419 -29.2453 -49.1617 7.39509 -4834 4 15.4971 26.9949 40.3155 1.17426 12.5786 14.7177 -4835 4 16.1446 27.3092 38.9602 29.5915 33.502 -22.8309 -4836 6 4.38071 13.8775 40.883 9.27553 -14.126 -4.37485 -4837 4 5.31782 13.6454 41.0342 -11.8393 4.50398 0.960258 -4838 4 4.04834 13.2497 40.2173 2.13772 10.7877 7.68198 -4839 6 20.1656 10.4005 38.218 10.8779 4.82467 -13.4554 -4840 4 20.4848 10.7245 37.3555 -10.2589 -5.36296 0.708096 -4841 4 20.9923 10.2607 38.6798 -1.28838 -2.71386 11.844 -4842 6 15.1666 19.24 23.8849 4.49083 -8.21488 3.46045 -4843 4 15.3253 20.1347 24.2296 -1.0797 -1.90309 -4.08137 -4844 4 15.0239 19.3391 22.9299 0.969961 5.53483 11.956 -4845 6 47.8934 28.614 15.7995 12.3109 16.1315 8.54118 -4846 4 47.9523 27.7003 15.5425 0.10403 -15.196 -3.00888 -4847 4 48.6265 28.752 16.4246 -6.57835 -5.21115 -6.70139 -4848 6 29.9259 30.9075 18.965 7.62461 4.23841 -1.37457 -4849 4 29.1117 30.4308 18.7732 -7.06282 -5.88302 -2.4339 -4850 4 29.7134 31.8391 18.8515 -2.57834 1.4724 1.74445 -4851 6 11.9338 35.8178 28.497 -7.27451 6.14295 -10.3733 -4852 4 12.5041 35.9802 29.2427 6.70347 11.4983 16.16 -4853 4 12.1847 34.9375 28.2428 -3.53576 -18.0038 -9.26428 -4854 6 29.972 37.8772 25.486 -12.1052 4.73031 -22.3992 -4855 4 30.2553 36.9663 25.6711 3.40868 8.54106 4.83275 -4856 4 30.3747 38.5051 26.0898 8.03536 -1.45294 10.6494 -4857 6 52.6584 28.1048 32.275 31.4311 4.91254 4.04956 -4858 4 52.2473 28.8547 31.8392 -9.38068 2.35947 -3.12986 -4859 4 53.5924 28.4001 32.3224 -6.05351 -9.99886 1.81474 -4860 6 37.0156 40.0823 11.982 15.2095 -8.99172 -8.52195 -4861 4 36.22 40.5624 12.1833 -15.2617 4.79593 6.40041 -4862 4 37.4101 39.8767 12.8402 0.665617 -0.484924 4.09883 -4863 6 16.6662 16.7824 36.4899 -23.6543 20.4081 -13.3107 -4864 4 16.0299 17.4889 36.7962 20.061 -22.8424 -10.9222 -4865 4 16.728 16.9177 35.5139 -3.3638 -0.555369 18.7216 -4866 6 27.9984 4.17668 38.8431 -6.8633 -1.77316 4.22536 -4867 4 28.9161 4.3061 39.1095 4.06977 1.67187 2.70396 -4868 4 28.0368 3.69267 38.0106 -3.95018 -5.40445 -5.6405 -4869 6 28.9057 0.266004 17.7212 -6.10073 29.2375 -5.44551 -4870 4 28.1786 0.88303 17.5246 8.92385 1.95552 -1.67076 -4871 4 28.4447 41.3635 17.8399 -11.0591 -30.1495 5.35559 -4872 6 22.9291 20.1009 26.2737 12.905 2.01461 18.3128 -4873 4 23.6265 20.0378 26.9508 -1.05622 -6.52034 -10.1156 -4874 4 22.4706 20.8929 26.5742 -3.00423 3.39878 -4.61403 -4875 6 49.3993 29.9017 13.433 -6.38025 27.1117 -0.919919 -4876 4 49.1201 30.8275 13.1802 1.84527 -26.9682 8.98406 -4877 4 48.7504 29.5045 14.041 1.51099 8.43883 -0.914593 -4878 6 2.44855 24.8301 7.30401 -10.5471 2.4163 20.698 -4879 4 2.41495 24.6588 8.2845 -1.1432 9.4633 -23.8545 -4880 4 1.72338 25.455 7.1058 6.30785 -9.44609 7.39061 -4881 6 30.3915 26.4508 14.3344 -6.38639 41.9339 41.7386 -4882 4 31.0669 26.3804 15.0403 -0.162406 -14.5956 -15.076 -4883 4 29.932 27.2875 14.6522 8.5071 -34.3491 -22.1885 -4884 6 27.0361 32.5047 3.13805 -13.013 14.5566 5.91638 -4885 4 26.4776 33.1542 3.63465 13.8957 -14.3888 -12.6314 -4886 4 27.3381 31.8882 3.81715 0.997102 -1.94867 -0.811892 -4887 6 34.2693 14.8073 1.28197 14.9869 -24.9335 -24.2287 -4888 4 35.1732 14.4308 1.1613 -12.3133 12.1546 9.27146 -4889 4 33.7818 14.2606 0.617478 5.51233 18.0169 18.4334 -4890 6 30.0243 8.54272 1.33127 -15.3984 1.11418 15.9731 -4891 4 29.9557 9.47917 1.12547 1.89625 5.05184 -1.94546 -4892 4 29.278 8.4251 1.95594 13.4411 -5.55834 -8.66406 -4893 6 42.5535 11.5155 27.7085 15.437 -3.44919 -13.726 -4894 4 42.3225 12.4337 27.8881 -6.79772 -1.02898 5.45325 -4895 4 41.899 10.9203 28.077 -14.0379 1.06089 7.70623 -4896 6 52.4658 39.5603 17.8381 6.64956 -28.6351 -32.0971 -4897 4 51.7413 39.7621 18.3991 -22.9429 13.2738 25.1291 -4898 4 53.1708 40.1592 17.9962 19.9289 22.995 10.0024 -4899 6 33.211 4.92827 31.629 -12.2211 32.167 9.39859 -4900 4 32.8163 5.83971 31.6275 7.84415 -21.2817 2.59476 -4901 4 32.9135 4.52627 30.8083 -0.68235 -2.18314 -5.10952 -4902 6 6.29493 15.9859 18.7482 13.6791 10.985 9.78561 -4903 4 5.93033 16.6016 19.4273 2.88753 -17.718 -13.1605 -4904 4 5.60754 15.3724 18.4768 -10.6912 0.909102 4.08099 -4905 6 8.51749 14.5386 24.6879 -5.02573 1.07483 -2.93277 -4906 4 9.38168 14.4087 25.0828 4.4136 1.3116 3.34168 -4907 4 8.20169 13.6557 24.4566 1.37146 0.850768 1.15416 -4908 6 22.6856 10.1159 32.1347 3.63858 -5.5341 -7.29103 -4909 4 22.4401 11.0127 32.2731 -27.0162 20.0988 15.0061 -4910 4 23.4682 10.3148 31.6383 25.2173 -15.197 -13.8617 -4911 6 11.2884 2.11431 14.6724 -33.0968 -7.95794 -19.898 -4912 4 10.3134 2.08073 14.4479 21.8664 -1.34414 10.3974 -4913 4 11.7152 2.30811 13.8211 9.70644 2.30495 0.939267 -4914 6 44.9099 15.5878 36.2745 25.7257 2.41581 -13.4012 -4915 4 45.0546 15.5553 35.3019 -10.2235 2.9059 20.3658 -4916 4 43.9848 15.4747 36.4307 -17.7944 -2.84066 -0.111047 -4917 6 9.72168 19.0116 31.2214 10.0341 -21.2505 -12.9994 -4918 4 10.5925 19.389 31.3727 0.996524 0.534629 3.32861 -4919 4 9.08651 19.5363 31.6795 -15.0033 12.5653 12.9482 -4920 6 51.9861 7.59179 16.6767 -2.21949 13.5197 0.492591 -4921 4 52.6037 6.8327 16.6765 -16.3843 6.63384 -16.8766 -4922 4 51.5083 7.75362 15.8118 21.6515 -16.4571 17.7861 -4923 6 31.4364 34.7816 36.4086 3.08769 21.0155 -3.2672 -4924 4 31.7704 34.8477 37.2975 8.82098 -13.2304 13.8104 -4925 4 31.3443 35.7177 36.1951 -3.32863 3.82124 -15.3061 -4926 6 4.22848 15.0876 15.3675 -15.1793 -4.71932 15.5862 -4927 4 4.10446 14.9036 16.3273 5.02277 2.80423 -15.2934 -4928 4 5.16622 15.2495 15.2447 10.6913 1.67801 0.337818 -4929 6 47.7535 20.6847 28.0297 3.73811 3.24498 -1.95167 -4930 4 47.6703 19.7739 27.6852 3.21079 12.9013 3.0329 -4931 4 48.3469 21.1738 27.4217 -9.1514 -8.95746 6.26441 -4932 6 15.7983 1.14885 24.4111 -6.64534 16.957 -16.446 -4933 4 15.3695 0.397874 24.8496 -11.2605 5.13601 -9.62176 -4934 4 15.1572 1.72115 23.8957 14.1067 -25.56 23.4483 -4935 6 34.5718 39.7067 40.0668 -5.06722 14.7699 1.92827 -4936 4 34.1159 40.1215 40.7935 -0.0189783 27.8984 7.01187 -4937 4 34.2456 38.8495 40.221 -5.22714 -44.7262 -10.8544 -4938 6 20.1936 32.176 34.4055 -22.5016 27.7868 41.3602 -4939 4 19.6673 32.7687 35.0502 14.2298 -29.0143 -30.198 -4940 4 21.0584 32.1328 34.8407 -2.28869 -2.39527 -4.5293 -4941 6 19.3074 38.5208 11.8317 17.689 14.4135 -2.63233 -4942 4 19.236 37.5914 12.0232 -0.177798 -10.0936 4.99209 -4943 4 20.0172 38.8749 12.4245 -13.7536 -7.85063 -8.99287 -4944 6 6.52955 13.5023 26.836 -16.6143 37.6784 -17.6139 -4945 4 6.084 14.0762 26.1427 18.8957 -21.2062 24.9102 -4946 4 6.49663 12.6281 26.4634 0.197125 -15.4908 -4.14034 -4947 6 23.5952 31.5638 33.3318 1.16311 -12.5666 -5.83621 -4948 4 23.0836 31.562 34.1475 0.610672 3.97154 0.891929 -4949 4 23.5328 30.6432 33.0053 1.46337 8.27478 -1.79938 -4950 6 41.0778 31.9114 16.1974 16.3032 -14.6541 -18.8682 -4951 4 41.8878 32.072 16.7344 -12.1593 -9.44827 -16.6375 -4952 4 41.2894 31.3264 15.4036 6.53327 16.9697 25.199 -4953 6 31.7476 18.8699 19.3483 9.2825 22.1595 5.37598 -4954 4 32.0642 19.7361 19.7036 -9.20895 -19.367 -8.68372 -4955 4 31.4026 18.3831 20.1168 1.10858 -0.37958 -4.48043 -4956 6 10.4875 4.12209 19.3444 6.70816 11.4672 -10.0773 -4957 4 9.70261 4.48263 18.8666 20.7562 -4.21822 -0.723312 -4958 4 11.3166 4.33216 18.8218 -27.5212 -3.06207 15.0001 -4959 6 1.37991 32.4635 19.2846 24.7257 -29.6508 -15.3303 -4960 4 1.97113 31.6954 19.1311 -3.90248 7.07021 19.3035 -4961 4 1.16609 32.6455 18.3731 -9.24935 13.5936 -9.63824 -4962 6 42.8716 16.8513 24.9892 37.8526 -21.8211 -51.5646 -4963 4 42.4398 17.6894 25.0051 -12.6784 17.6471 3.13223 -4964 4 43.4179 16.871 24.1222 -26.4831 0.994324 39.976 -4965 6 45.3183 19.1979 4.10041 6.37956 15.045 3.35342 -4966 4 46.1127 19.7887 4.04575 -15.2131 -7.48775 2.85843 -4967 4 44.6191 19.6898 4.58798 10.0124 -1.75765 -5.61527 -4968 6 29.1291 19.8804 35.7574 13.154 -41.1853 -12.3735 -4969 4 28.6049 20.2559 36.4387 -19.4183 16.2678 16.1743 -4970 4 29.3151 20.5439 35.0927 -1.78114 11.3903 -2.63997 -4971 6 31.9353 21.8377 19.6787 8.2762 14.7684 -3.54893 -4972 4 32.7301 21.8918 19.0885 -22.5823 -4.29925 15.9785 -4973 4 31.6692 22.7774 19.8195 3.83825 -20.8185 -1.08359 -4974 6 39.1936 8.26228 18.8336 -23.7578 16.4079 -2.4793 -4975 4 38.9784 7.343 18.63 -1.41923 -3.63173 -0.882922 -4976 4 38.3593 8.77699 18.6285 24.7505 -17.6369 4.60834 -4977 6 33.27 13.2649 41.2621 -10.1289 -28.0457 11.6457 -4978 4 32.3532 13.5818 41.1472 2.43324 -1.71459 -0.314725 -4979 4 33.2053 12.355 41.6729 1.3348 20.3333 -9.56947 -4980 6 5.93721 29.5458 35.7995 -7.4397 -15.3695 -5.23966 -4981 4 6.3797 30.3135 36.1022 6.42857 23.5026 12.0451 -4982 4 6.51225 29.246 35.0987 1.02237 -6.8727 -9.18458 -4983 6 13.023 34.1764 31.9266 -10.1581 -4.84889 27.419 -4984 4 13.003 33.3874 31.3637 -4.82745 -5.23795 6.11925 -4985 4 12.6053 33.9771 32.8123 10.4055 -1.49763 -26.3146 -4986 6 33.9757 21.8032 17.9969 16.1152 -19.1834 -4.43927 -4987 4 34.6651 21.0941 18.0436 -13.0194 10.1005 -1.31384 -4988 4 34.4424 22.6001 17.7557 11.611 10.6919 -5.33679 -4989 6 35.9777 41.3398 18.1614 -6.56463 -6.11943 -26.9477 -4990 4 35.8856 41.423 17.1648 6.35377 -3.40276 32.4743 -4991 4 36.5823 0.128109 18.4064 3.22136 6.47441 1.04719 -4992 6 34.856 37.6452 30.5972 -0.647303 3.94572 7.36538 -4993 4 35.2577 36.9607 30.0196 0.445186 1.06156 15.4535 -4994 4 34.8848 37.3986 31.5588 5.49281 -5.52744 -23.9922 -4995 6 25.9972 34.4216 4.68589 -10.7784 -9.94602 -21.2075 -4996 4 25.3582 34.53 5.39473 2.66172 5.48603 12.8385 -4997 4 26.8259 34.8497 4.89674 4.47855 8.12742 13.9663 -4998 6 19.0606 33.5662 1.31783 4.31184 23.0948 -29.5486 -4999 4 19.7493 33.0549 1.74461 7.17592 -5.61608 3.87291 -5000 4 19.5019 34.1007 0.592753 -8.94353 -18.7796 23.9626 -5001 6 25.2721 8.22916 8.60038 8.3672 -6.50911 13.4278 -5002 4 25.4774 8.1828 9.55838 -2.37789 7.03817 -10.0574 -5003 4 25.4001 9.14285 8.30246 -0.229164 -0.61302 1.82749 -5004 6 12.8408 19.6874 13.0432 23.1779 -10.767 -3.57874 -5005 4 11.9236 19.9359 13.0109 -16.1394 8.08564 -1.3752 -5006 4 13.3549 20.4875 12.8299 -11.6819 -5.55115 1.76181 -5007 6 53.3458 11.4322 5.81729 13.7919 -26.0181 10.511 -5008 4 53.941 11.999 6.3288 -5.2171 7.54934 -1.97002 -5009 4 52.6156 11.905 5.44666 -11.025 16.6744 -4.72885 -5010 6 9.84401 16.0447 31.1965 1.52473 25.7097 1.4485 -5011 4 9.0725 15.75 30.7245 -12.2986 -10.5074 -10.4763 -5012 4 9.76401 17.0228 31.1974 4.09395 -10.8484 3.46066 -5013 6 25.4337 20.2897 3.31222 -0.0744965 -16.6885 15.2888 -5014 4 25.4502 20.7681 4.1742 1.29774 3.58896 -22.0188 -5015 4 25.617 20.9088 2.59036 0.892976 4.59184 10.0233 -5016 6 20.7687 8.19442 15.6442 -13.8219 -45.5838 -0.24202 -5017 4 20.3131 8.5145 16.4113 -6.16339 18.6345 13.1662 -5018 4 20.3525 7.29833 15.5772 17.5129 18.5489 -8.91575 -5019 6 37.6537 8.61162 9.99803 6.38032 -10.5281 17.8344 -5020 4 37.9174 7.70722 10.2264 -2.01487 8.44182 4.78342 -5021 4 37.3414 8.51532 9.10193 -3.86116 3.7435 -6.65528 -5022 6 50.6588 4.51187 24.2729 -10.1552 -3.70856 6.87258 -5023 4 49.9071 3.88527 24.1971 13.583 4.61791 0.248303 -5024 4 51.4381 4.036 24.5943 -3.42543 -3.47462 2.6777 -5025 6 20.1632 24.8244 34.8962 -12.0105 28.899 -22.2545 -5026 4 19.9486 25.4522 34.1467 5.29317 -18.0262 19.0072 -5027 4 20.331 23.9626 34.5117 -0.31696 -10.3492 -2.27521 -5028 6 30.5785 22.522 11.2467 -2.76969 13.8933 23.9619 -5029 4 31.2526 22.1243 10.7257 13.2932 -13.8734 -17.1472 -5030 4 31.019 23.338 11.5119 -11.6942 5.7798 2.38886 -5031 6 17.322 40.803 8.03266 14.2969 -15.2802 9.14469 -5032 4 17.3696 39.9923 8.55945 -20.3131 5.85274 7.92005 -5033 4 18.1352 40.6655 7.5489 4.4024 9.10004 -19.1526 -5034 6 23.9661 41.0457 26.0803 21.1205 -0.428792 10.5169 -5035 4 24.3123 40.6207 25.2948 17.4674 -5.32369 -4.96192 -5036 4 23.0464 41.0448 25.8953 -36.0489 4.67224 4.09659 -5037 6 9.79449 25.5813 27.216 11.7002 -20.4303 -20.1428 -5038 4 10.1564 25.0129 26.491 -8.57195 17.3601 17.171 -5039 4 10.1924 25.2359 28.0288 -3.53182 0.239058 0.558234 -5040 6 35.2535 29.8267 24.7533 16.8399 6.514 6.92542 -5041 4 34.3962 29.6585 24.3475 -6.29365 6.70405 -5.90439 -5042 4 35.51 30.7547 24.57 -10.2352 -8.20594 -2.77553 -5043 6 2.14051 4.25227 10.5512 -4.35014 2.09559 7.87868 -5044 4 1.87018 4.24401 11.51 4.03105 2.56783 -22.6964 -5045 4 1.48695 4.75313 10.0317 0.0426026 -1.98947 12.7879 -5046 6 43.1755 3.92129 23.5016 -16.6861 -14.9885 0.818311 -5047 4 43.8939 4.14262 22.9078 7.68421 2.83398 -7.81803 -5048 4 42.5577 3.34913 22.9937 11.3891 7.34243 2.48813 -5049 6 18.8996 22.6297 2.43765 22.7339 -13.1014 -2.24121 -5050 4 19.79 22.181 2.40524 -25.7911 11.1615 4.63986 -5051 4 18.7139 22.8085 3.37028 4.18935 -2.21949 -1.21374 -5052 6 20.4908 18.9405 41.5599 0.284845 -17.4141 21.8797 -5053 4 20.1374 18.6064 0.533469 2.69626 22.1818 -33.2143 -5054 4 19.9839 19.6587 41.147 -4.56676 -6.01516 12.1125 -5055 6 26.4163 7.55623 29.1338 1.47231 -3.25042 -11.8229 -5056 4 25.7099 7.08251 28.6481 8.40182 7.03804 13.9135 -5057 4 27.0821 7.71224 28.4448 -4.02075 -2.1597 11.7889 -5058 6 25.6465 35.5679 33.7595 -11.9902 -19.4032 2.16293 -5059 4 26.3374 36.2384 33.6103 2.60319 -14.9989 -6.30077 -5060 4 25.8315 34.6987 33.2841 2.54327 33.8846 12.2934 -5061 6 24.8333 0.493635 8.41989 34.5336 11.5552 47.2955 -5062 4 25.5249 0.302877 9.1499 -35.8013 6.01564 -39.2036 -5063 4 24.7614 41.6068 7.91956 0.436288 -16.6888 -13.1367 -5064 6 17.008 17.3182 3.45493 -26.2706 15.7324 15.4846 -5065 4 16.2426 17.9829 3.53843 29.8189 -30.5055 4.13684 -5066 4 17.1653 16.9244 4.35506 -11.2277 16.1793 -19.3505 -5067 6 40.1827 32.1035 19.3506 13.0539 -5.95213 0.358733 -5068 4 39.8335 31.2604 19.604 -25.4023 -11.2285 12.0125 -5069 4 40.9513 31.7409 18.9215 18.5667 14.352 -9.19942 -5070 6 23.3808 26.7171 6.31746 29.0762 21.4976 14.3842 -5071 4 24.13 27.3908 6.46801 -30.1018 -19.5893 -7.69607 -5072 4 22.7349 27.0723 5.68536 3.11778 6.18165 -0.6273 -5073 6 28.6527 28.5112 1.41186 -10.6623 -30.4119 4.69741 -5074 4 28.683 29.4458 1.20631 15.125 4.74584 -7.70298 -5075 4 29.5288 28.0803 1.2704 -12.115 26.7011 1.44139 -5076 6 12.0438 6.3157 14.0384 -8.70244 -3.06108 -4.52058 -5077 4 11.2798 6.1721 13.4181 27.4537 -0.215786 8.28745 -5078 4 12.8925 6.19521 13.5554 -16.057 2.9292 1.41242 -5079 6 20.1243 33.7022 32.0954 -30.4257 7.53408 -8.19993 -5080 4 20.1371 33.1054 32.8412 7.6416 -5.80656 10.7415 -5081 4 21.0197 33.8732 31.8382 18.9224 -1.8204 -0.321518 -5082 6 12.0625 33.3632 34.5388 -0.325915 -41.4281 -23.9157 -5083 4 11.5602 33.8727 35.1697 -10.674 0.646784 10.687 -5084 4 11.6234 32.4653 34.3673 14.5179 34.5198 8.14895 -5085 6 6.00279 22.2605 25.0501 2.06163 -11.5991 79.3474 -5086 4 5.88194 22.3996 24.153 -16.4068 14.8809 -57.8418 -5087 4 5.25089 22.6367 25.5854 16.5977 -6.05374 -22.2773 -5088 6 28.8802 9.48792 11.0269 30.0757 -27.8021 5.60101 -5089 4 29.142 10.167 11.6644 -15.2392 1.2069 -12.766 -5090 4 28.0854 9.70897 10.5587 -15.7703 15.13 -3.00542 -5091 6 25.9783 31.1564 24.8742 0.212243 -23.2246 11.0271 -5092 4 26.2703 31.9474 24.4305 5.78101 9.73635 -10.8861 -5093 4 26.5948 30.4205 24.6499 -9.08002 14.2421 1.82694 -5094 6 17.4069 22.6321 26.9528 -11.8732 29.0046 13.506 -5095 4 17.1509 23.4374 27.5137 11.798 -28.7792 -23.9739 -5096 4 17.5283 21.9112 27.5803 0.671776 -8.09241 2.21186 -5097 6 30.9731 17.6144 1.64569 13.582 26.8251 31.1357 -5098 4 30.2123 17.6859 1.07719 -13.0538 -2.75682 -13.3747 -5099 4 31.0067 18.4528 2.19078 1.05257 -25.2161 -14.5596 -5100 6 35.2833 9.73343 11.2271 -16.277 -4.62114 -26.0747 -5101 4 34.627 9.45499 10.5137 29.3374 5.62349 25.4867 -5102 4 36.1567 9.37366 10.9701 -6.28276 0.375521 -3.01301 -5103 6 12.0057 10.8077 4.27601 -12.2512 -1.40581 -7.43609 -5104 4 11.4458 10.5898 5.05281 2.39288 0.24657 -15.6405 -5105 4 11.51 10.5288 3.46435 7.55978 2.35404 20.8087 -5106 6 52.9546 23.1284 7.66438 3.19212 11.9041 -9.13647 -5107 4 53.8155 23.0936 7.22037 1.72331 -6.21969 -0.472682 -5108 4 52.7997 24.0739 7.82392 -0.633169 -8.94194 3.43433 -5109 6 27.374 5.80114 23.1096 7.51778 12.7335 11.6917 -5110 4 28.1753 5.52132 23.6349 -22.415 18.9583 -13.4562 -5111 4 27.3645 6.79042 22.9959 5.3793 -33.2455 5.89418 -5112 6 22.7689 37.6996 15.5372 -5.91943 -7.67105 33.7333 -5113 4 22.8436 37.842 14.6084 2.14719 5.97904 -25.5056 -5114 4 23.2999 36.9284 15.7907 -0.822855 1.46565 -2.93441 -5115 6 30.5901 30.1355 39.7465 -8.92084 9.99629 -19.6672 -5116 4 30.0839 29.6315 39.0953 -1.54922 -9.94816 6.16305 -5117 4 30.5761 31.0154 39.3281 8.00114 -4.73058 9.29019 -5118 6 26.5152 14.8694 29.9646 3.93344 -0.205179 -3.29595 -5119 4 25.7559 15.3094 30.3103 -24.5604 12.1261 -1.41502 -5120 4 27.0839 14.9289 30.718 22.1413 -5.57177 12.178 -5121 6 9.52543 19.5487 37.4182 -4.93509 -3.75546 7.04348 -5122 4 8.56858 19.5373 37.6772 20.7537 10.8584 -9.00922 -5123 4 9.7741 20.4052 37.0166 -14.5013 -9.56436 9.93265 -5124 6 0.91928 14.8658 2.69601 -17.5095 9.99019 63.3715 -5125 4 1.47581 15.1737 2.02419 28.2707 8.36374 -43.6031 -5126 4 1.18821 15.4309 3.47389 -7.04008 -21.0896 -18.5042 -5127 6 46.427 27.1287 41.5945 43.2461 -1.33556 -25.8044 -5128 4 47.402 27.2052 41.2817 -46.4011 -2.64418 15.4668 -5129 4 46.0299 26.5803 40.8989 0.996959 5.24299 8.87294 -5130 6 47.678 23.0562 21.3872 5.44089 38.3346 6.01366 -5131 4 46.9403 23.2179 20.8133 -13.997 9.90145 -6.64011 -5132 4 47.7418 22.1285 21.385 8.56341 -43.7487 4.99103 -5133 6 39.8587 22.235 3.08723 2.37939 -15.5871 -9.21378 -5134 4 39.0088 22.2526 3.53641 -4.44104 7.43329 4.08383 -5135 4 39.9535 21.2857 2.86173 -0.917299 22.2801 6.61021 -5136 6 14.9853 14.9328 33.4647 9.90785 18.6887 5.96998 -5137 4 15.4024 15.8269 33.5858 -13.0369 -24.3412 -0.758701 -5138 4 14.5599 14.6915 34.3048 3.28451 6.61064 -6.43534 -5139 6 27.3302 11.4834 31.9317 -27.4366 -15.9755 21.8219 -5140 4 26.9982 12.0952 32.5883 -9.79098 -5.70708 8.51591 -5141 4 28.0752 11.9422 31.6406 46.9031 18.536 -28.2392 -5142 6 36.7579 7.97089 7.62034 -1.24967 -18.9477 -14.6485 -5143 4 35.954 7.42009 7.70022 6.4697 6.94413 -3.0671 -5144 4 37.4142 7.36122 7.22008 -3.07725 6.9494 1.66736 -5145 6 49.4451 9.66335 18.2174 -4.20907 -17.0946 -5.32386 -5146 4 50.1075 10.0642 17.6138 -11.2883 10.4151 20.0604 -5147 4 49.0937 10.2089 18.9473 16.8995 10.9543 -13.1485 -5148 6 27.0353 33.866 10.7555 -3.61813 20.4819 39.0174 -5149 4 27.1089 33.3944 9.9425 -11.0368 -7.55411 -28.9907 -5150 4 26.1735 34.332 10.8422 4.28798 -12.7598 -13.2634 -5151 6 11.1949 37.4624 6.84871 0.36549 -16.8746 15.3404 -5152 4 10.8648 38.3395 6.66289 0.465253 11.7734 -2.90488 -5153 4 12.1583 37.5341 6.85599 1.64848 0.115814 -1.2743 -5154 6 19.2537 19.4156 21.9114 -15.7985 8.22585 33.6704 -5155 4 18.5515 19.3251 21.2863 -16.3583 -5.26309 -15.3133 -5156 4 20.0646 19.323 21.4355 25.7859 -3.53787 -14.4318 -5157 6 54.4972 2.91444 22.5674 41.6328 11.7794 25.4635 -5158 4 54.323 3.09449 21.6644 -16.7292 4.15243 -34.296 -5159 4 0.405558 3.31869 22.7045 -24.6299 -12.807 4.19326 -5160 6 45.0583 10.8549 24.2301 5.83399 20.0221 21.0618 -5161 4 44.4296 11.5751 24.1426 -7.03973 -3.51443 -9.4179 -5162 4 45.6095 11.2138 24.9523 4.1225 -19.1196 -10.3672 -5163 6 14.387 34.402 24.7643 -0.614961 -5.50567 -8.46915 -5164 4 14.802 35.2302 25.0278 -0.621724 2.17228 4.67692 -5165 4 14.8142 34.1913 23.9221 -0.527667 -3.77388 -2.27373 -5166 6 50.586 17.557 4.30707 17.1275 -18.9627 18.6811 -5167 4 51.3126 17.9927 4.759 8.45418 -3.82203 7.11351 -5168 4 50.1863 18.2804 3.88376 -26.598 27.5468 -24.7799 -5169 6 14.9317 33.3337 34.1113 -12.3404 20.8418 56.9019 -5170 4 15.0455 32.9404 33.2912 5.44957 -23.8922 -53.334 -5171 4 14.0148 33.1563 34.3942 8.12215 6.97131 -5.23034 -5172 6 20.8706 33.5768 38.9143 15.1188 7.04694 -15.6549 -5173 4 20.7999 34.008 39.7578 -2.44584 7.66125 17.1111 -5174 4 20.3826 32.7659 38.9944 -10.1095 -18.4284 -0.973943 -5175 6 7.78494 4.73961 26.7587 18.7098 -5.63937 13.378 -5176 4 7.2181 5.0845 27.4506 -5.7435 6.37459 2.19378 -5177 4 7.246 4.75931 25.9687 -5.82922 -1.99593 -5.70414 -5178 6 9.28281 21.4851 22.3014 51.087 14.0475 -25.6174 -5179 4 8.74732 21.9732 21.6886 -31.0609 5.1079 -5.58489 -5180 4 10.1706 21.7227 21.8793 -22.1752 -18.3044 28.8298 -5181 6 20.5441 38.2146 8.8638 -2.83914 11.917 26.817 -5182 4 20.3663 38.6401 9.7626 4.81036 -21.6973 -30.7816 -5183 4 20.4013 37.2533 8.94236 -1.07384 9.24152 7.62946 -5184 6 30.1053 39.0795 30.7451 -13.6764 41.2724 28.6819 -5185 4 30.3998 39.946 31.2193 -9.10868 -42.8123 -24.766 -5186 4 29.1169 39.0706 30.8728 28.3121 -0.882933 -5.94109 -5187 6 16.0486 22.0268 24.5039 34.2787 3.60452 0.906339 -5188 4 16.7735 22.0671 23.8432 -14.3833 -3.87047 -0.289875 -5189 4 16.5419 22.3002 25.3044 -14.2176 -3.36187 3.5873 -5190 6 5.74232 29.2062 14.4594 -18.34 10.8061 -32.1404 -5191 4 6.48422 28.7094 14.7814 11.5218 -3.49899 17.506 -5192 4 5.24211 29.6259 15.1721 5.10135 -5.91064 9.04276 -5193 6 28.0673 3.08827 25.2267 -6.08854 1.42804 12.0746 -5194 4 28.6661 3.71086 24.7756 -7.19123 -0.840207 10.3279 -5195 4 27.7106 3.5203 26.0449 13.0908 -0.523763 -20.3567 -5196 6 45.9319 29.2971 31.4223 -7.33073 21.7818 28.5056 -5197 4 45.7264 28.738 30.6765 -12.0419 -4.51403 -16.7723 -5198 4 45.1872 29.9464 31.611 20.2512 -24.9239 -13.0948 -5199 6 11.2178 22.8398 36.7928 3.83605 7.6889 -19.1741 -5200 4 10.7288 23.4227 36.1801 1.54849 -6.36416 6.79315 -5201 4 12.0227 22.5824 36.3 -5.92076 -0.954096 11.0422 -5202 6 18.9236 40.1387 39.9284 -8.72712 -15.4473 12.674 -5203 4 19.137 39.1923 39.9727 -1.01676 1.76774 -7.47997 -5204 4 18.926 40.4024 40.8597 -1.95632 5.76083 -1.10583 -5205 6 23.5567 26.0801 21.2876 -20.8354 -5.58511 20.4095 -5206 4 22.8283 26.6117 20.9473 7.44123 1.31497 -7.03875 -5207 4 23.1869 25.6705 22.0991 12.7429 3.57595 -14.6326 -5208 6 16.8309 5.38685 15.8596 17.5735 -24.6285 20.3591 -5209 4 16.4468 5.29371 14.9868 -10.6119 14.9975 -0.930521 -5210 4 16.6163 6.1995 16.3389 -7.69088 7.65746 -13.895 -5211 6 12.049 26.6129 14.9962 1.83385 5.07399 -16.0821 -5212 4 11.6864 25.936 15.5307 6.55853 -24.3886 27.1256 -5213 4 11.2609 26.839 14.5085 -0.894459 16.8406 -16.785 -5214 6 14.3334 41.4222 2.37421 26.0216 21.5484 -18.2857 -5215 4 13.7051 40.9662 2.90199 -22.7144 -12.1023 21.977 -5216 4 14.3738 0.426145 2.71152 -4.41702 -11.6567 2.07407 -5217 6 50.4009 35.8582 9.31454 24.1561 17.2373 -12.1424 -5218 4 50.8168 35.8748 8.42953 -10.1576 -5.67977 3.83986 -5219 4 50.8977 36.5714 9.7704 -11.7974 -14.2445 3.10197 -5220 6 11.3695 22.6672 26.8678 6.20997 3.92483 11.2558 -5221 4 12.2048 22.3333 26.5164 -4.88328 -1.76893 -0.685046 -5222 4 10.6892 22.391 26.2565 -8.40373 -4.36232 -8.95219 -5223 6 8.45148 34.5593 21.2814 -25.9919 -59.0281 13.1791 -5224 4 8.04792 35.0446 21.9998 -0.548909 12.0582 7.93151 -5225 4 8.02348 33.6171 21.3881 27.3669 48.26 -12.6189 -5226 6 9.41918 8.68911 24.4735 -32.1109 22.232 -11.1027 -5227 4 8.45415 8.80658 24.2608 22.5553 -3.45738 3.03744 -5228 4 9.54271 9.26889 25.2379 6.1219 4.18012 4.13063 -5229 6 32.6166 22.3351 34.507 3.90791 9.0503 -27.7323 -5230 4 32.5036 23.1955 34.0662 0.599489 -5.17288 -1.28756 -5231 4 32.8196 22.6091 35.3861 6.87298 3.84758 30.2519 -5232 6 26.7427 26.1702 7.11338 18.0622 8.0778 -11.4877 -5233 4 26.0574 25.7087 7.60312 -9.51312 -3.43645 7.19196 -5234 4 26.4504 27.0916 6.97179 -2.60416 -16.0173 4.37043 -5235 6 33.9976 11.9299 3.97475 -1.16308 1.75568 6.69865 -5236 4 33.7915 11.6388 4.87314 3.4696 4.99202 0.68255 -5237 4 33.8545 12.8906 3.99294 -0.306808 -3.71184 -1.40707 -5238 6 21.4819 20.9256 37.2108 -8.76322 20.972 13.918 -5239 4 22.36 21.3309 37.2026 5.25525 -6.97128 0.105034 -5240 4 21.5739 19.9858 37.0637 7.9716 -15.2147 -3.23728 -5241 6 18.467 41.0278 0.654954 -19.554 -29.5721 -12.8619 -5242 4 17.5024 41.1258 0.530294 8.77033 6.01734 2.0842 -5243 4 18.8042 41.8885 0.845086 4.40915 26.8371 2.49279 -5244 6 41.3548 41.7118 25.1844 12.9409 14.5374 -0.392323 -5245 4 40.9222 40.8883 25.4041 -6.90081 -12.2223 3.22908 -5246 4 41.5202 41.6634 24.2378 -1.56977 -0.361026 -1.444 -5247 6 27.6369 28.1312 3.93858 39.9773 31.9241 -60.8173 -5248 4 27.7577 28.1455 2.91253 -1.05119 3.80663 52.0412 -5249 4 26.945 27.5412 4.09124 -36.8498 -31.9254 8.70709 -5250 6 18.2839 10.5111 31.4966 0.533258 -0.0130678 0.979798 -5251 4 17.4029 10.1636 31.5665 -10.6602 -13.9647 -0.00296819 -5252 4 18.1106 11.4466 31.5267 10.9856 11.4938 1.12981 -5253 6 11.3036 37.9694 14.764 4.77413 -10.0896 11.5971 -5254 4 10.7874 37.239 14.4221 -9.53089 5.23111 -9.63971 -5255 4 11.7579 37.5414 15.5118 -2.30342 16.6377 -5.07599 -5256 6 0.816524 18.1414 27.5647 20.1272 -0.3628 -0.469578 -5257 4 0.17179 17.4415 27.469 -11.396 -5.37013 -1.78049 -5258 4 1.63281 17.6507 27.785 -7.45447 11.2502 -1.88757 -5259 6 36.8008 10.7378 20.295 8.4208 9.86458 8.47872 -5260 4 36.1948 10.0642 20.0001 -9.44027 -8.16387 -5.04241 -5261 4 36.5983 10.8279 21.2363 1.65531 0.40354 2.85938 -5262 6 47.4201 25.5213 8.04394 8.74054 5.57223 -13.14 -5263 4 47.3566 25.6372 7.0634 -2.71671 -4.96685 23.4826 -5264 4 46.5708 25.2582 8.40304 -6.39129 0.734124 -5.55138 -5265 6 13.9238 35.1275 16.0037 32.5083 18.1998 3.59786 -5266 4 13.2022 34.5755 16.1957 -32.489 -30.3694 18.6715 -5267 4 13.7597 35.4303 15.121 4.25156 9.41728 -20.5426 -5268 6 29.562 35.3734 16.1776 -35.0835 -2.07929 -8.00281 -5269 4 30.2224 34.9599 16.7245 13.9673 -5.91711 9.2078 -5270 4 28.7051 34.8863 16.2926 25.5199 12.926 -4.35301 -5271 6 29.4722 25.8866 32.4187 14.354 2.72026 -23.1845 -5272 4 28.9025 25.7608 33.1796 -14.4011 -9.23541 2.43376 -5273 4 29.1922 25.3818 31.6086 -3.9853 6.0929 23.1903 -5274 6 24.1343 2.13601 25.4438 45.8363 12.8335 -27.0328 -5275 4 24.6226 2.81425 24.8647 -23.4035 -21.9591 22.2831 -5276 4 24.7019 1.32842 25.3981 -18.0817 13.4017 1.18969 -5277 6 4.54354 34.4275 19.14 11.1292 -12.0398 21.377 -5278 4 4.4735 34.5954 18.1883 -15.738 1.03246 1.7136 -5279 4 3.71635 34.4131 19.6775 9.89222 2.06937 -18.6971 -5280 6 10.1248 17.2257 14.3121 -1.66581 -5.60367 -9.60454 -5281 4 10.2583 17.5937 15.1679 8.8306 2.43924 21.0325 -5282 4 9.4989 17.8227 13.9164 -6.75609 1.38519 -13.487 -5283 6 21.4392 41.7587 34.6855 22.2624 7.769 -11.2018 -5284 4 21.5032 41.1211 35.405 -13.4071 -7.19641 7.36579 -5285 4 20.544 -0.0182627 34.3462 -4.72666 -12.2957 11.4101 -5286 6 36.1543 24.108 12.5954 -4.82194 -9.49577 -8.67068 -5287 4 35.691 23.694 13.3698 5.25066 1.62288 -23.6525 -5288 4 35.776 23.8018 11.7194 2.97337 4.42231 26.8685 -5289 6 49.5838 18.601 19.9434 7.37368 0.836531 -4.03301 -5290 4 50.0063 19.3607 19.4891 -2.40205 -12.3461 5.19746 -5291 4 50.2865 17.9356 20.0577 -3.44895 8.52353 -2.14521 -5292 6 1.26001 7.05318 14.4907 38.3056 -26.8237 -27.7837 -5293 4 1.8201 6.82299 13.6677 -23.9217 11.4061 34.9177 -5294 4 1.48256 6.35829 15.148 -4.21477 12.5307 -9.57675 -5295 6 12.7431 22.7759 31.2417 -21.5742 -17.6245 -17.2109 -5296 4 12.7068 22.0167 30.6251 -0.189583 12.5272 11.0438 -5297 4 13.6543 23.0267 31.2833 20.8009 4.17698 1.04357 -5298 6 8.18693 18.6259 27.8062 12.2535 -2.56913 -7.18349 -5299 4 8.40416 17.6764 27.919 2.05523 15.8207 -2.89848 -5300 4 8.90605 19.0032 27.258 -7.77238 -10.2714 7.52916 -5301 6 52.132 28.0244 15.3085 -5.0475 -8.46487 8.97907 -5302 4 52.2845 27.4141 14.5747 1.7297 4.34316 -0.517396 -5303 4 52.1194 28.9169 14.9336 2.1814 -6.82244 -4.33507 -5304 6 52.6909 21.916 10.0977 -8.33066 3.09691 2.06611 -5305 4 53.4463 22.3007 10.5387 10.5159 5.84972 4.87058 -5306 4 52.7807 22.2562 9.19728 -3.40401 -0.944397 -1.81328 -5307 6 22.3502 5.78024 2.67711 -1.19821 4.70475 8.9403 -5308 4 22.3462 5.61537 3.63751 1.98719 -8.03511 -7.01348 -5309 4 22.5962 4.95479 2.25163 2.53332 -12.0932 -0.158426 -5310 6 15.4205 16.2192 21.8867 5.02822 24.0999 -40.4778 -5311 4 14.4784 16.2102 22.0595 -10.022 -3.20892 10.2198 -5312 4 15.4767 16.6809 20.9929 2.09736 -16.6333 30.6862 -5313 6 28.7089 41.2927 33.91 5.52796 3.54283 5.25404 -5314 4 28.727 40.4953 34.4564 -2.79359 -2.24742 -0.170863 -5315 4 27.7951 41.4466 33.6263 4.57527 -2.88437 3.84631 -5316 6 9.01739 31.2727 18.2059 -18.1749 -3.84142 11.7815 -5317 4 8.98151 32.2312 18.3694 0.025829 -3.44513 1.18933 -5318 4 8.52849 30.7949 18.9304 13.8496 11.5721 -17.6376 -5319 6 20.5529 20.3981 18.1799 -10.2473 -3.12886 -8.71499 -5320 4 21.0329 20.6151 18.9854 0.125323 4.65459 7.73128 -5321 4 19.8496 21.0773 18.075 13.4895 -10.4913 3.92819 -5322 6 53.9703 14.7072 37.8312 5.01214 -4.5628 8.74013 -5323 4 53.4666 15.4974 37.9319 -5.56379 24.6001 14.4542 -5324 4 53.6093 14.375 37.0321 1.20033 -18.5897 -21.23 -5325 6 28.9035 15.3885 18.8586 45.4636 -15.1916 -0.680493 -5326 4 29.8469 15.0873 18.5932 -41.6456 12.1347 6.71251 -5327 4 28.9115 15.3505 19.8299 -3.5302 1.25595 -2.12016 -5328 6 2.00256 25.8212 18.9096 3.72723 11.471 14.7099 -5329 4 2.26458 26.6216 18.4327 2.14682 1.88771 -0.892997 -5330 4 1.76414 25.179 18.2501 -5.23937 -11.562 -15.1322 -5331 6 53.2507 40.704 24.2965 8.91441 12.4597 1.37217 -5332 4 53.4683 39.7911 24.0958 -2.511 -10.6834 -0.444896 -5333 4 54.079 41.1598 24.0633 -8.96863 1.63956 3.52407 -5334 6 47.5231 32.0042 22.8531 -14.3462 4.46803 -6.08063 -5335 4 47.3408 32.7709 23.4273 6.00779 -4.56073 2.25025 -5336 4 48.2766 31.5253 23.2067 4.67997 4.39959 7.43042 -5337 6 24.6197 26.1463 33.0089 -12.4366 -5.18424 3.68853 -5338 4 24.4183 25.6868 33.835 -4.3875 -0.159577 -1.83724 -5339 4 25.4547 26.5812 33.1385 10.0429 5.3772 -3.83199 -5340 6 21.3442 17.0884 39.4824 -9.75867 4.42788 -12.86 -5341 4 22.0786 16.6105 39.8509 9.0034 -0.419098 8.66004 -5342 4 20.9617 17.649 40.1682 3.71874 -0.284678 5.70811 -5343 6 11.0324 40.4486 17.0358 15.7971 -30.8577 -26.0801 -5344 4 11.6842 41.1185 17.2103 4.65986 12.9737 2.4903 -5345 4 11.491 39.8695 16.3608 -26.1319 15.9634 25.4848 -5346 6 20.3416 21.2702 39.8615 -24.9835 10.9638 22.3655 -5347 4 20.689 20.9793 39.0389 13.9219 -9.37305 -28.7546 -5348 4 21.0638 21.2843 40.4958 4.25493 1.29328 -0.298347 -5349 6 2.11091 29.6941 22.5934 -5.9509 -23.8702 -11.6938 -5350 4 1.45034 28.9715 22.5035 1.67869 13.3355 3.97539 -5351 4 2.94117 29.2559 22.3631 0.0654014 9.01208 -1.60678 -5352 6 36.7558 30.2897 35.4506 24.3729 -18.3256 16.5828 -5353 4 36.1768 30.1398 36.2224 6.47664 5.98183 -7.75951 -5354 4 37.6324 29.8684 35.7011 -26.9845 14.5763 -5.36474 -5355 6 12.9471 4.31284 37.9204 -6.90268 -11.166 6.10722 -5356 4 12.3078 3.59731 38.1765 12.7034 25.1114 3.17689 -5357 4 12.7446 5.19856 38.3152 -2.40344 -19.0082 -2.01981 -5358 6 38.3332 5.26794 18.4655 -19.3496 19.9027 -29.1997 -5359 4 37.4721 5.17942 18.8804 2.72791 -1.29988 8.64573 -5360 4 39.0241 5.01488 19.0552 15.587 -10.1496 24.0772 -5361 6 10.4858 9.23289 21.7404 -25.2332 -4.10139 2.16313 -5362 4 10.1465 9.25623 22.657 12.6022 -3.18555 -3.91704 -5363 4 11.447 9.27854 21.7188 5.40032 0.87934 7.2107 -5364 6 0.505771 41.0407 17.3245 -0.427706 37.3637 0.906459 -5365 4 1.03474 40.3115 17.5973 10.8601 -24.0642 8.3812 -5366 4 1.07952 41.8285 17.484 -10.202 -14.0113 -5.73388 -5367 6 4.10283 5.07754 6.43738 -38.2782 -14.6693 -26.7901 -5368 4 4.80956 4.44559 6.48511 17.8781 -6.62955 4.00539 -5369 4 4.33824 5.81877 6.9517 16.1672 26.1823 21.8329 -5370 6 11.4353 25.4218 0.164599 -6.84764 4.42394 -1.26617 -5371 4 11.3082 26.3017 0.56247 4.23965 -3.25035 1.30302 -5372 4 12.32 25.1006 0.40702 -4.64442 7.63092 -0.276853 -5373 6 7.41885 21.5502 8.10769 10.495 -13.722 -26.2993 -5374 4 7.61759 21.2522 7.17802 -11.0567 9.56016 28.8323 -5375 4 8.26229 21.8826 8.44859 -7.90548 -1.09713 -4.6635 -5376 6 47.5869 16.3678 25.2584 -15.0789 15.5873 -32.807 -5377 4 46.6352 16.1327 25.0388 32.9447 8.00435 6.4503 -5378 4 47.9767 16.8704 24.4584 -11.2605 -20.3751 33.7323 -5379 6 30.9209 19.4939 39.8451 -11.8548 28.7526 -24.1689 -5380 4 31.8555 19.5183 40.0202 17.1254 -10.6903 10.4692 -5381 4 30.8076 20.3562 39.3598 -8.87252 -26.4956 11.5622 -5382 6 20.3775 24.0331 39.393 16.2123 32.2964 -6.62361 -5383 4 19.46 24.2872 39.3788 -17.3162 -0.971439 2.40317 -5384 4 20.4139 23.0995 39.5119 -7.32592 -29.4126 2.4841 -5385 6 45.906 21.2665 41.1719 -24.2736 -11.4825 -0.885762 -5386 4 46.5804 21.1569 41.8486 15.7955 10.6383 -1.5802 -5387 4 46.0859 21.9477 40.5132 15.7742 6.36757 6.57249 -5388 6 32.5682 28.1996 30.46 3.6658 -10.99 6.0107 -5389 4 32.938 27.299 30.6104 -6.7941 21.8776 -2.09353 -5390 4 33.2105 28.8285 30.8344 -2.85996 -8.65293 -4.24176 -5391 6 18.0144 1.30598 27.0418 -16.6632 -1.71712 -0.445992 -5392 4 17.1007 1.69106 27.0468 26.0213 -5.17059 4.63351 -5393 4 18.4653 1.60291 27.8546 -9.34219 2.14994 -8.02835 -5394 6 39.3706 24.9704 21.8707 -3.8719 -7.6304 -3.05608 -5395 4 39.4638 25.9303 22.0078 -2.06007 -5.24545 2.56571 -5396 4 38.5004 24.7369 22.2528 8.08795 9.92494 -4.1564 -5397 6 33.5838 21.3134 22.0984 8.18441 -4.13225 6.82001 -5398 4 32.7138 21.3502 21.682 2.4933 6.37883 -5.99313 -5399 4 34.1113 22.092 21.8324 -12.1677 -4.37971 -1.53996 -5400 6 40.113 14.9986 15.7558 -14.3933 -54.3129 -47.4443 -5401 4 39.335 14.6192 15.2293 31.4969 18.6384 20.9479 -5402 4 39.7901 15.7154 16.2477 -17.7573 36.9578 24.811 -5403 6 32.6916 17.9228 6.36161 -9.89813 9.73379 -21.0853 -5404 4 32.6423 17.3002 7.0662 1.70901 -17.6566 26.5232 -5405 4 32.2464 17.4542 5.63975 -0.790726 3.03073 -5.51736 -5406 6 50.4678 15.9334 31.144 -39.7004 -26.5385 31.9374 -5407 4 51.253 16.1743 30.7093 39.9028 11.8107 -24.2063 -5408 4 50.5343 14.9829 31.3801 -1.18751 16.0768 -7.78774 -5409 6 23.825 29.3336 31.6412 17.8706 -6.79638 -8.14744 -5410 4 23.7507 29.695 30.7549 -4.03414 2.57591 0.878238 -5411 4 24.7016 28.8907 31.6365 -14.4802 6.46497 6.02506 -5412 6 25.0497 41.6479 38.28 3.49637 2.98657 -6.73496 -5413 4 25.6848 41.2957 37.6072 -14.3525 10.6226 12.6055 -5414 4 24.5759 0.544247 37.957 10.7828 -14.7666 -1.7986 -5415 6 14.3338 25.4719 8.00129 -34.0608 -17.9542 9.33499 -5416 4 15.0375 25.807 7.49197 32.7442 17.1809 -19.3974 -5417 4 13.7504 25.049 7.33286 9.67269 6.09785 11.4563 -5418 6 17.2157 20.7463 5.33337 -33.6161 12.1619 46.6806 -5419 4 17.4746 20.2104 4.61987 19.6997 -12.8632 -39.6831 -5420 4 17.6039 21.6267 5.33982 9.69266 2.06371 -12.0346 -5421 6 18.8632 10.9532 23.7128 -6.45661 -28.7698 -18.1749 -5422 4 18.5024 10.4645 22.9505 4.54871 -4.25462 9.96764 -5423 4 18.7195 11.8343 23.4273 2.43458 32.1183 3.28403 -5424 6 7.79185 41.3929 11.0465 3.42517 6.73563 9.75028 -5425 4 8.03468 40.5075 11.3396 -5.29569 0.405018 -3.04036 -5426 4 8.54504 0.0288503 11.3371 -5.83581 0.184768 -2.76634 -5427 6 48.7029 23.1861 34.0656 -21.7207 -4.36764 -18.9996 -5428 4 48.0685 22.9631 33.3267 17.6914 7.49561 22.5851 -5429 4 49.5647 23.2306 33.645 9.38657 -0.0360042 -3.96825 -5430 6 53.7171 23.5593 15.3279 7.98903 18.1369 9.52531 -5431 4 53.9889 24.0987 14.5512 -16.5338 -16.4319 -0.0123194 -5432 4 53.1679 22.8017 15.1046 0.0193492 2.24596 -12.2178 -5433 6 22.2331 5.62812 9.84443 -1.57081 2.06392 2.32933 -5434 4 21.8309 4.81719 9.48029 9.17546 11.008 0.0652314 -5435 4 22.6135 6.1669 9.11622 -10.9942 -17.7486 8.8339 -5436 6 33.6597 8.39756 9.07438 12.888 -3.30103 7.28088 -5437 4 32.9598 8.97334 9.38893 -12.3292 7.33717 0.65351 -5438 4 33.4682 8.16911 8.16186 -5.09418 6.09353 -6.44604 -5439 6 47.3119 37.7194 20.3363 21.5156 22.744 3.03657 -5440 4 47.6473 37.5407 19.4464 -9.46862 -8.33692 4.35957 -5441 4 46.6883 37.0359 20.5464 -12.6113 -19.4741 -3.99141 -5442 6 30.8566 16.7294 10.6197 -45.1927 -36.7422 15.3603 -5443 4 30.4293 17.2093 11.3782 10.0419 -7.15869 -15.9692 -5444 4 30.3248 15.8445 10.5087 28.8517 44.18 3.4025 -5445 6 48.1145 27.7388 10.1259 3.61398 12.7601 13.975 -5446 4 49.0121 27.5791 10.4269 8.16567 7.74751 7.8449 -5447 4 47.9875 27.049 9.49259 -14.0608 -13.1923 -17.2023 -5448 6 27.3333 38.6223 25.6028 2.23096 -19.4823 3.9502 -5449 4 28.2552 38.3493 25.5855 1.31221 -11.4567 4.08925 -5450 4 27.4115 39.4856 25.2253 -6.51803 21.9055 -3.11379 -5451 6 33.3641 5.73966 21.4502 -17.8674 16.1521 -18.7045 -5452 4 32.7333 6.1391 20.8022 11.3762 -13.0233 18.1576 -5453 4 34.2053 6.04196 21.1266 17.0109 2.35293 -3.511 -5454 6 25.3113 5.14231 4.52483 0.627568 -0.448638 -4.7772 -5455 4 25.9311 5.01166 5.26368 -5.83567 -1.85096 0.781095 -5456 4 24.4169 4.85751 4.79359 12.9854 0.158453 3.02285 -5457 6 40.4761 35.641 19.148 -1.79116 -1.08437 4.96155 -5458 4 40.617 35.2798 20.0294 1.97887 -12.6912 2.42284 -5459 4 40.4316 36.5735 19.3404 -1.08207 12.5153 -8.94186 -5460 6 49.6577 30.6259 19.0198 10.1565 -2.14928 -32.2041 -5461 4 49.9169 29.8714 18.4657 1.24638 0.0316256 -4.24874 -5462 4 49.4705 30.2089 19.8368 -7.31172 -12.6811 36.7039 -5463 6 42.1447 28.3235 17.0346 32.2065 -21.7575 -5.76428 -5464 4 41.8825 28.1658 16.1189 -9.06503 7.62036 -2.3435 -5465 4 42.9622 27.7534 17.0825 -24.1402 18.2728 2.552 -5466 6 47.7039 24.5139 36.3396 16.4403 6.39896 -6.79461 -5467 4 46.9537 23.9582 36.5487 -4.01092 -10.0931 -4.11437 -5468 4 48.0889 24.2445 35.4833 -10.0455 -7.86437 4.89019 -5469 6 19.3463 26.9837 19.8062 -14.9609 -0.640093 12.1457 -5470 4 19.5138 26.0435 19.7544 7.81166 -12.6546 -12.1749 -5471 4 18.7209 27.0489 20.5386 2.91516 7.38851 -4.99075 -5472 6 47.0534 26.8134 37.524 14.5946 -27.4581 20.3182 -5473 4 46.5999 27.4025 36.9765 -27.9132 42.868 -22.1392 -5474 4 47.3287 26.1433 36.896 5.92816 -9.16339 3.59921 -5475 6 9.30604 24.6864 40.2824 32.5721 -4.72803 4.84631 -5476 4 9.7425 23.8424 39.9878 -14.1318 19.2209 8.44319 -5477 4 10.0514 25.1942 40.7028 -19.8613 -12.5192 -10.8686 -5478 6 14.4861 17.9115 14.2864 12.9549 -2.10551 -8.28408 -5479 4 13.7677 18.2592 13.7435 1.92348 1.2648 2.86628 -5480 4 15.2633 17.8567 13.6783 -18.4643 2.67645 15.1406 -5481 6 37.1346 38.6824 18.7128 7.24689 -5.58535 -9.53541 -5482 4 36.7159 39.5508 18.578 6.84706 -0.690413 -9.37485 -5483 4 37.7177 38.457 17.9456 -10.6272 10.0511 7.65618 -5484 6 11.4119 5.91281 21.4549 8.51563 -6.63227 17.2429 -5485 4 12.0074 5.45436 22.0841 -12.0343 5.82261 -11.8758 -5486 4 10.9825 5.24051 20.9122 -1.087 -4.70833 -2.40093 -5487 6 4.25375 30.708 16.2346 29.3973 -34.9884 0.269827 -5488 4 4.09384 31.4404 15.6668 -11.3131 25.7038 -10.6546 -5489 4 3.7498 30.7826 17.0293 -13.4231 7.50595 13.7704 -5490 6 17.6719 16.0027 27.067 -23.8279 -26.0778 -36.6424 -5491 4 17.4271 15.046 26.968 10.0078 22.1048 9.82572 -5492 4 17.2008 16.3672 26.2667 15.5193 1.39518 21.9495 -5493 6 36.5109 8.65039 40.4308 12.8187 7.82554 4.51092 -5494 4 36.6212 9.57953 40.6523 1.70353 1.63484 0.0365135 -5495 4 35.6422 8.38915 40.7323 -7.59123 -4.26386 -1.28756 -5496 6 13.6114 12.9582 3.02589 -9.62347 -2.84414 10.0553 -5497 4 13.2363 12.4097 3.76862 19.3807 16.1747 -17.4749 -5498 4 14.4444 13.4268 3.2396 -7.87441 -9.64772 8.81761 -5499 6 38.5595 20.1494 21.6232 12.4359 -2.6335 16.4863 -5500 4 39.2259 20.3435 20.9591 -1.48691 0.443177 -6.45697 -5501 4 37.7118 20.0829 21.2013 -17.1516 -4.14152 -12.2545 -5502 6 50.9933 10.2578 30.842 -13.0607 -20.693 1.71035 -5503 4 51.4592 11.0512 30.6346 13.219 20.5706 -0.472754 -5504 4 50.4501 10.1493 30.0523 -4.00654 -4.85851 -2.78428 -5505 6 16.2749 2.41767 41.3132 30.43 46.2693 -10.4997 -5506 4 15.891 1.63581 41.6436 -18.412 -43.9133 0.0464609 -5507 4 16.2795 2.47169 40.3396 -9.09423 -14.5759 6.47164 -5508 6 16.5834 4.98938 41.8776 -7.21709 18.0228 -35.1788 -5509 4 16.7462 5.00964 0.881122 10.2158 10.5242 44.5139 -5510 4 16.3516 4.0781 41.7536 -3.71457 -12.9135 -9.58407 -5511 6 38.2173 37.6461 20.9885 34.7311 9.53448 3.02785 -5512 4 38.1039 38.1836 20.1861 -3.89758 -6.06348 6.62032 -5513 4 39.1638 37.7895 21.271 -30.6928 -4.57838 -6.40603 -5514 6 27.3006 1.89931 15.7822 -29.9599 0.296682 7.03709 -5515 4 27.5073 1.31215 15.0574 1.93116 -3.76907 -9.96281 -5516 4 26.3073 1.90747 15.8082 23.9237 -0.0762349 1.33551 -5517 6 29.0265 12.4386 37.8107 0.525722 -10.271 3.33822 -5518 4 29.5022 13.2884 37.7591 0.646351 -6.15481 8.15455 -5519 4 29.2991 11.9227 38.6151 -0.523918 21.8031 -11.8471 -5520 6 46.0742 20.1649 18.9021 10.3528 7.89056 -10.7305 -5521 4 45.1842 20.5502 18.8696 3.90233 0.901411 -3.14496 -5522 4 46.6469 20.7119 18.3183 -8.66547 -7.99067 8.59505 -5523 6 2.04022 38.6829 18.5084 -2.98341 9.82285 -40.3455 -5524 4 2.90324 38.7749 18.9245 -0.612017 -3.29975 20.9344 -5525 4 1.3228 38.3823 19.0758 6.43327 -3.78011 20.6074 -5526 6 44.0503 24.9822 25.9794 4.67294 -4.59524 3.88497 -5527 4 44.3373 24.0607 26.0767 4.76241 4.2408 6.41339 -5528 4 43.5759 24.9717 25.1449 -4.92835 3.44315 -2.97359 -5529 6 5.98031 26.6293 4.53551 9.30387 5.64625 14.1271 -5530 4 6.57491 27.1353 5.14729 -11.3776 -17.0368 -12.135 -5531 4 6.21313 25.677 4.5841 -4.82905 19.4284 -2.02229 -5532 6 0.0924267 23.2133 10.9333 1.42961 0.53672 3.80218 -5533 4 0.717354 23.7388 10.4004 2.9288 -9.65077 10.1872 -5534 4 0.580921 22.6863 11.5989 -3.01683 9.30052 -9.37626 -5535 6 39.1222 20.6154 12.8741 28.3348 2.95161 0.461931 -5536 4 40.0468 20.8249 13.1753 -23.4009 -9.33487 -2.82098 -5537 4 38.9932 21.1408 12.0685 -0.0080483 -0.226832 2.68059 -5538 6 39.959 39.9495 18.871 8.01281 1.93571 -21.8826 -5539 4 39.6441 40.4313 18.0693 6.09748 -11.7745 18.4856 -5540 4 39.3412 40.1359 19.5607 -16.2687 5.42221 11.8382 -5541 6 49.288 23.0046 30.5128 21.2206 -9.75551 18.5897 -5542 4 49.5389 23.7528 30.0013 -1.98497 24.1116 -29.9204 -5543 4 49.9896 23.0569 31.1809 -5.40626 -11.587 6.30696 -5544 6 10.3545 2.34292 9.14765 -20.562 40.259 12.8074 -5545 4 10.1012 1.5797 8.68555 -3.02669 -36.876 -18.9145 -5546 4 9.58966 2.94108 8.9894 20.4134 -0.423974 9.05106 -5547 6 9.6115 40.9317 19.7379 12.0905 -27.6191 -4.08509 -5548 4 9.69139 40.7751 18.7589 3.32448 -0.840478 24.839 -5549 4 9.96472 40.0953 20.2033 -15.7711 32.9781 -27.126 -5550 6 29.2535 5.10379 17.4957 6.62295 15.7752 6.05206 -5551 4 28.9547 4.7998 16.6324 -1.76299 0.290572 -5.22762 -5552 4 29.5626 6.02275 17.3534 -3.29284 -14.1281 1.20249 -5553 6 27.0956 15.411 3.22262 8.43004 -47.4217 3.28637 -5554 4 27.2677 16.3043 3.38591 1.16524 52.1129 6.18754 -5555 4 27.741 14.9724 3.82188 -13.792 3.46242 -10.72 -5556 6 32.8341 39.3821 25.1177 -1.66938 -44.1854 21.376 -5557 4 32.6253 40.2767 24.9331 -7.27917 31.8978 1.68524 -5558 4 32.4689 39.1753 26.0219 6.68592 11.3878 -26.9617 -5559 6 34.9613 7.8883 31.2358 4.6626 36.0744 6.61898 -5560 4 34.1778 8.39814 31.5057 7.62156 3.23778 -2.6687 -5561 4 34.6431 7.01199 31.2355 -6.57887 -35.8668 -2.78431 -5562 6 6.13276 36.7597 26.1434 10.8988 16.6869 20.3463 -5563 4 6.63888 37.4372 26.6797 -12.2659 -21.448 -21.9021 -5564 4 6.61066 36.5785 25.3331 5.0666 0.722926 -2.43587 -5565 6 6.00975 25.8323 24.1014 -4.47961 0.932019 -2.36624 -5566 4 6.35352 25.3647 24.9068 -18.3984 14.8695 -13.0656 -5567 4 5.16189 26.3111 24.2876 18.65 -15.8322 7.58859 -5568 6 45.6302 24.3945 2.56021 19.8484 -5.54431 -0.0961329 -5569 4 46.4674 24.0527 2.19931 -2.34639 0.0383291 -2.49188 -5570 4 45.6784 24.1611 3.48508 -4.52597 -1.56916 11.2469 -5571 6 15.5147 11.7041 32.683 14.9804 20.126 19.7749 -5572 4 15.7333 12.537 33.1619 -4.31998 -20.325 -9.45866 -5573 4 14.9494 12.0119 31.9786 -9.0483 1.88099 -11.1618 -5574 6 46.4109 17.7015 37.4781 -27.0258 -32.7931 -28.9932 -5575 4 46.5427 17.8951 38.3867 3.19976 6.65122 29.0636 -5576 4 45.8763 16.8534 37.4192 15.4316 28.8096 -0.764517 -5577 6 39.7197 20.9143 18.534 -24.0731 20.2285 32.8184 -5578 4 40.3775 20.5463 17.9571 20.7324 -0.0260386 -6.5243 -5579 4 40.0771 21.5962 19.1648 -0.0511872 -19.8333 -22.8182 -5580 6 23.8035 28.041 36.6748 9.0016 14.1447 -6.24075 -5581 4 23.3139 27.2938 37.064 2.44252 16.2828 7.25552 -5582 4 23.789 28.845 37.2599 -7.88527 -27.7019 -2.97202 -5583 6 23.2344 0.634844 30.8976 -0.384503 -14.0448 -5.97485 -5584 4 23.3889 41.8653 31.5825 6.30765 2.44689 -9.38002 -5585 4 23.8441 0.49945 30.133 -8.72578 -2.57312 14.648 -5586 6 37.1436 6.89172 28.2858 -3.37167 6.44507 30.6351 -5587 4 36.8056 6.23733 28.9583 11.2574 17.9183 -21.3683 -5588 4 37.4325 7.68669 28.8192 -8.94015 -21.4647 -17.7418 -5589 6 3.23535 6.60909 12.3935 -1.87368 1.73448 8.36027 -5590 4 3.03832 6.9284 11.4867 8.20532 -9.84476 7.71099 -5591 4 3.52123 5.67427 12.3822 -6.77188 11.8795 -6.70084 -5592 6 12.6173 19.1518 31.1213 -5.69854 -18.2223 8.29425 -5593 4 12.5903 18.2248 31.5183 -0.203161 27.8336 -18.7857 -5594 4 12.2771 19.1425 30.2049 2.23067 -5.60852 14.6148 -5595 6 15.1884 38.3149 41.5578 -3.57026 -0.303434 0.776802 -5596 4 15.4085 38.7623 40.7331 -1.55695 3.41656 0.7558 -5597 4 16.0064 37.8692 41.7958 4.70682 -3.66196 2.37744 -5598 6 49.6308 33.3399 19.6427 -23.754 -26.2674 -4.71234 -5599 4 48.6425 33.4171 19.8493 35.7001 -9.4047 -10.4581 -5600 4 49.8006 32.395 19.3286 -9.63678 35.3831 11.1391 -5601 6 6.36026 2.78098 29.8944 3.74937 13.951 -9.77631 -5602 4 6.39713 3.75696 29.8119 -0.635871 -14.0149 2.80012 -5603 4 6.09114 2.63212 30.8044 -1.55083 -4.44243 9.60337 -5604 6 13.1715 31.7798 30.2783 -11.6407 3.9064 -21.9894 -5605 4 12.793 31.9725 29.3819 8.72012 -0.590438 18.6573 -5606 4 12.9685 30.8401 30.4245 2.82441 5.28785 4.26217 -5607 6 32.3245 32.246 24.8932 -0.334642 -17.4514 3.51608 -5608 4 32.5833 31.3985 24.4266 1.55373 29.7789 3.70352 -5609 4 32.7413 33.0821 24.5914 4.2936 -14.9539 -9.40787 -5610 6 41.9919 14.5701 37.4124 -31.8928 -38.2057 -11.1184 -5611 4 41.1925 13.9916 37.278 11.7187 28.3557 2.93562 -5612 4 42.6351 13.8531 37.4242 20.2579 6.94588 1.70752 -5613 6 11.8923 7.24234 27.6655 -13.1666 -25.4093 6.94854 -5614 4 11.7936 6.42612 28.2118 8.91213 18.8361 -2.40188 -5615 4 11.255 7.06027 26.9538 4.64331 9.73453 -0.841263 -5616 6 14.1973 37.538 6.88791 4.07782 -38.2298 -28.3639 -5617 4 14.4575 38.4426 6.80778 6.05638 30.4198 1.96843 -5618 4 14.5936 37.1092 6.07523 -12.6749 10.0326 27.426 -5619 6 14.2479 30.6948 36.0545 7.37408 36.4971 9.0133 -5620 4 14.3981 30.7629 35.1101 2.39159 -10.6067 -11.9788 -5621 4 14.1779 29.7876 36.2972 -1.09854 -35.7585 -0.14866 -5622 6 16.4334 33.6494 5.49228 -9.96541 -28.1856 -5.39099 -5623 4 16.7983 34.5397 5.45321 9.37649 -3.55324 -12.1003 -5624 4 16.7788 32.9912 4.81355 -0.655183 31.9156 12.6517 -5625 6 23.0317 17.1547 7.8473 13.6053 -0.132883 9.10362 -5626 4 22.1841 17.362 7.40272 9.91908 10.567 10.3381 -5627 4 23.4804 17.9296 8.30446 -24.7767 -19.3244 -18.4116 -5628 6 51.7425 20.8913 27.7088 32.6403 -5.30395 6.54704 -5629 4 51.4526 20.615 28.6066 9.31531 5.01366 -13.1678 -5630 4 52.7523 20.9899 27.7096 -40.0215 -4.95426 2.55021 -5631 6 2.19474 27.6072 28.8013 -23.9703 3.8216 12.4498 -5632 4 2.89306 28.2617 29.0045 8.22653 -14.998 -10.5048 -5633 4 2.42593 26.8662 28.2089 10.4722 10.3682 5.46115 -5634 6 17.2069 14.3387 7.70681 0.210359 -30.5014 22.2216 -5635 4 16.8342 14.1932 8.62484 13.2745 1.87397 -27.442 -5636 4 17.791 13.5503 7.49447 -17.8498 26.4292 5.4189 -5637 6 12.462 8.93964 14.7065 0.798528 8.71873 -6.67623 -5638 4 12.2438 7.98523 14.5568 11.6803 11.8078 17.0064 -5639 4 13.0577 9.12873 15.4809 -12.5262 -17.6243 -12.8578 -5640 6 42.4139 38.0579 9.76413 -20.5008 17.2265 16.0611 -5641 4 43.2035 37.8944 10.2554 20.3834 -6.45835 6.72371 -5642 4 41.8905 38.6035 10.3913 3.31942 -7.4886 -15.3201 -5643 6 51.8227 30.3513 28.272 -27.6927 -20.9124 31.2363 -5644 4 51.4089 31.1514 27.9711 0.163888 16.7369 -10.597 -5645 4 52.6546 30.2313 27.8441 24.1641 3.9866 -16.3823 -5646 6 0.181148 18.531 4.58976 -5.95747 22.8787 14.3331 -5647 4 0.30783 18.164 3.72574 1.94264 -10.8238 -19.8991 -5648 4 0.385506 17.861 5.23812 2.38695 -15.8688 4.81738 -5649 6 34.1492 0.61754 2.99129 -49.6439 4.42439 -16.0687 -5650 4 33.2398 0.938351 2.63038 43.5613 -10.8791 15.5023 -5651 4 34.8325 1.13587 2.566 3.67212 10.3309 -6.27046 -5652 6 49.171 17.2374 23.1529 12.6877 -22.0026 -17.2704 -5653 4 50.1002 17.5391 23.0823 -12.4494 -3.65532 2.68691 -5654 4 49.1558 16.3609 22.6932 2.16788 22.8154 9.36775 -5655 6 23.1488 6.5083 23.6124 -20.5997 37.6057 -45.0229 -5656 4 23.0491 7.12001 22.8007 18.1878 -21.95 27.0503 -5657 4 22.2316 6.45775 23.8939 -1.28085 -6.53623 13.7239 -5658 6 11.0806 24.0842 29.2705 -8.73998 -10.3514 -18.9502 -5659 4 11.2441 23.4599 28.5168 0.0150655 10.4905 16.9308 -5660 4 11.7296 23.9083 29.9561 7.87164 -2.5542 2.12029 -5661 6 36.5429 4.08242 21.672 0.786556 -8.94696 -15.3954 -5662 4 36.4501 4.49554 22.5359 -3.35109 8.47972 1.84417 -5663 4 36.356 4.76727 20.9996 1.47044 -5.20042 11.1851 -5664 6 31.3053 25.6355 24.591 -3.66138 3.71718 3.54675 -5665 4 31.1335 26.2845 25.3159 5.93159 -20.4343 -13.8963 -5666 4 32.0778 25.0682 24.8002 -7.66178 11.3294 7.22687 -5667 6 42.6065 23.0403 14.7613 -16.8309 4.03618 -45.3098 -5668 4 42.9655 23.4598 13.9577 -8.276 -4.36486 -1.00498 -5669 4 43.204 23.3098 15.4118 29.6291 10.3091 46.448 -5670 6 14.3159 11.6727 8.8813 -14.5655 -17.9373 -12.2817 -5671 4 13.3434 11.4421 8.85146 29.9821 6.96631 -2.22077 -5672 4 14.7728 10.9717 8.34565 -11.3371 15.3318 14.175 -5673 6 21.498 2.14139 3.39648 14.7702 -17.8734 -6.06988 -5674 4 22.405 2.21099 3.73647 -11.0312 3.8274 -0.37696 -5675 4 21.4855 1.24815 2.9799 -4.51333 14.3419 9.54204 -5676 6 22.4606 27.6741 39.0725 -9.38699 -8.57051 -12.0691 -5677 4 22.9487 28.2157 39.6788 9.87489 12.9386 7.45564 -5678 4 22.251 26.9021 39.5804 -3.7481 -10.0177 3.53978 -5679 6 37.2705 33.4961 30.0614 -4.9469 -17.1986 11.1636 -5680 4 36.5019 32.9393 30.3108 14.0133 8.69925 -1.52787 -5681 4 38.0636 33.0902 30.4641 -13.5236 2.40347 -6.71067 -5682 6 41.8394 20.8621 40.0097 -20.8091 -17.9415 -11.9484 -5683 4 40.8821 20.7467 40.2088 17.4772 5.45688 -4.89215 -5684 4 42.2425 21.2111 40.795 8.11745 4.61319 15.3924 -5685 6 10.0509 31.1054 22.2556 20.3961 -18.8014 17.2446 -5686 4 9.98499 30.8639 23.2007 -4.95143 3.66172 -13.3958 -5687 4 9.23459 31.4918 21.9926 -24.2979 8.76968 -3.95477 -5688 6 24.2243 35.3747 6.62617 -9.42531 -3.96828 -6.7527 -5689 4 23.2865 35.2144 6.56466 -9.91939 -6.68958 -24.4488 -5690 4 24.2401 35.6133 7.54088 22.4532 10.3619 17.5563 -5691 6 54.2249 13.3694 18.759 -24.737 -0.349871 -1.41807 -5692 4 53.5933 13.3703 18.006 15.3609 1.78219 9.05355 -5693 4 53.6566 13.499 19.5435 10.7967 -0.400371 -8.89572 -5694 6 12.4855 25.1013 17.4456 -6.57337 13.5018 5.68311 -5695 4 11.9686 25.7405 17.9864 9.67417 -13.0798 -6.23069 -5696 4 12.9177 24.4729 18.0482 -8.67745 6.31928 -4.55572 -5697 6 22.3956 33.969 18.8874 -5.8063 -1.6479 -7.81353 -5698 4 22.8035 34.4497 18.1359 -8.0332 -6.19684 5.18696 -5699 4 21.6693 33.408 18.5182 22.6878 13.045 2.20471 -5700 6 24.4435 12.9292 5.84415 8.74588 -19.8564 16.0901 -5701 4 24.6262 13.8512 5.99703 -0.326218 20.1414 -4.57271 -5702 4 23.8078 12.8376 5.13214 -2.90401 5.95194 -4.82348 -5703 6 13.3959 11.2335 28.6038 -6.74888 -5.61354 -5.54718 -5704 4 13.7674 10.4842 28.0847 -9.93712 8.82772 12.9583 -5705 4 12.6218 10.8864 29.0903 8.08376 -4.51111 -11.0518 -5706 6 20.9645 34.7015 21.139 -6.51648 1.45471 -0.425004 -5707 4 21.4543 35.0255 21.9119 2.52902 -3.67403 -7.94594 -5708 4 21.5071 34.7067 20.3201 -1.1119 -0.149268 16.7291 -5709 6 37.136 34.5081 26.161 6.62209 -8.97684 -22.2932 -5710 4 37.2438 34.333 25.2112 -5.73965 -6.14541 10.65 -5711 4 37.5173 35.375 26.2088 1.33918 12.2816 12.8311 -5712 6 49.3593 27.1123 23.4681 27.9614 -13.0657 2.71617 -5713 4 48.46 27.3383 23.3348 -38.0547 10.3981 -3.53627 -5714 4 49.5827 26.632 22.6632 1.14175 -6.15755 -6.01297 -5715 6 2.6463 41.7198 27.6524 7.3894 17.9878 -25.5957 -5716 4 2.49639 41.7504 26.6775 -8.79282 -10.4379 14.5056 -5717 4 3.38399 0.440368 27.7439 -10.0848 -7.80081 10.7778 -5718 6 28.2486 5.66281 0.851705 -28.2484 -11.3463 5.20358 -5719 4 29.1342 5.88017 0.643235 30.8656 11.4658 -5.99415 -5720 4 28.269 4.69693 0.891643 -4.88577 1.64465 1.4719 -5721 6 46.3319 19.9354 30.6504 10.2867 19.401 8.99033 -5722 4 46.9123 19.9353 29.8821 -3.84989 -4.07474 -6.11394 -5723 4 46.5975 20.7732 31.0971 -12.3274 -18.5124 -2.17733 -5724 6 3.63748 25.7835 21.5531 -13.3498 -8.40935 -29.3244 -5725 4 3.82697 24.8656 21.7578 10.5845 0.467441 11.0774 -5726 4 3.24958 25.6945 20.6565 5.98204 10.7305 11.6574 -5727 6 2.75525 19.0991 29.6309 -15.3907 3.66354 13.2976 -5728 4 3.52302 18.6052 29.9384 7.69741 -2.11378 -3.28897 -5729 4 2.98375 19.5594 28.8227 11.6258 3.58084 -5.99316 -5730 6 11.8998 35.7779 24.2574 -1.81403 7.91701 -5.71356 -5731 4 12.4147 34.9912 24.3376 10.7342 -20.9531 7.85436 -5732 4 12.5443 36.3811 23.8879 2.19538 16 -3.69366 -5733 6 52.3427 30.4062 14.294 22.5839 4.39347 1.37497 -5734 4 52.8745 31.0934 14.7488 -8.66891 -1.23278 -4.46489 -5735 4 51.4935 30.7804 14.0876 -13.5204 11.8147 1.32314 -5736 6 0.0822874 24.3672 32.1291 -8.34182 -9.5272 -6.40877 -5737 4 0.828194 24.8082 31.7001 -5.59692 5.0286 6.41936 -5738 4 -0.0482457 24.7479 33.0025 4.35174 8.79498 5.58774 -5739 6 31.4966 23.7292 38.8152 19.1094 38.0757 -4.99319 -5740 4 31.5999 23.5133 39.7508 -8.21927 -12.2318 -1.63758 -5741 4 30.9751 23.0699 38.3783 -13.0662 -23.7861 4.62116 -5742 6 52.1169 21.6052 3.50792 14.3711 -14.904 -13.5765 -5743 4 52.8807 21.6364 2.89306 -16.3122 -4.91238 6.22228 -5744 4 52.1257 22.4771 3.8768 -2.65107 18.1744 9.91254 -5745 6 31.7478 33.9414 11.5999 6.40399 -14.705 -7.35618 -5746 4 31.326 34.316 12.3745 -3.98661 3.76902 9.36008 -5747 4 32.1024 33.0666 11.8569 -5.74966 15.1553 -0.43871 -5748 6 7.04869 17.6722 16.6738 15.5169 9.78585 -46.6303 -5749 4 6.86408 17.1452 17.4554 -1.12856 -17.4359 1.80272 -5750 4 7.18951 17.0724 15.8577 -9.09698 16.5018 49.1326 -5751 6 51.856 41.8666 22.1892 3.84753 25.5265 -21.3427 -5752 4 52.3772 41.4924 22.8897 9.65371 -13.9556 16.5062 -5753 4 51.0512 41.3628 22.1522 -12.8828 -14.9996 6.2925 -5754 6 50.8708 9.92691 25.9357 -19.3562 -16.2947 3.52683 -5755 4 50.5833 10.1225 25.0455 -2.85771 2.39787 -5.58996 -5756 4 51.6551 10.4289 26.0882 17.2727 16.0662 4.10656 -5757 6 8.99927 39.8664 13.8488 -8.14038 -13.6283 -23.156 -5758 4 9.59929 39.3497 14.3885 6.06913 -3.61279 3.55219 -5759 4 8.79522 39.3067 13.0547 7.60199 16.2117 22.1745 -5760 6 40.7023 25.5302 0.148896 6.79038 -13.4508 8.01702 -5761 4 40.3789 25.4701 1.07476 14.4856 1.96217 -11.1718 -5762 4 41.6802 25.6099 0.149801 -17.1473 -2.90233 2.89792 -5763 6 46.6909 7.84537 22.8702 9.17253 9.27189 2.7581 -5764 4 46.223 7.4121 23.6122 6.69651 11.5962 -1.82232 -5765 4 47.0858 8.70418 23.1544 -10.5797 -14.2101 5.83025 -5766 6 21.013 12.9106 9.96683 -11.4772 33.9385 12.3935 -5767 4 21.4714 12.292 10.5062 17.1864 -22.5118 18.142 -5768 4 21.2487 12.7153 9.07972 8.38308 -10.8862 -30.7653 -5769 6 24.8549 0.515446 28.6008 5.68052 19.4063 -7.13145 -5770 4 24.6132 0.0822417 27.7678 -2.25298 -0.561161 -0.933523 -5771 4 24.9931 1.46483 28.3802 -3.69568 -16.6941 4.65055 -5772 6 9.93738 22.6806 8.27387 -17.0851 30.8612 6.83622 -5773 4 10.4469 21.9921 7.84938 5.97494 0.327216 -18.4105 -5774 4 9.65147 23.3826 7.61609 12.4321 -25.0338 8.46255 -5775 6 33.2759 9.25001 23.8237 4.47891 -44.2955 15.8461 -5776 4 33.2652 10.105 23.448 0.909732 36.8069 -18.0196 -5777 4 34.1325 8.84557 23.5962 -5.93924 6.51534 1.57833 -5778 6 47.795 20.3665 34.2866 5.36639 25.6433 -13.2606 -5779 4 47.2589 21.0165 33.753 7.81309 -27.8153 16.882 -5780 4 47.2984 19.5618 34.502 -10.2742 8.68957 -7.27829 -5781 6 7.49437 13.498 41.0843 -1.51987 -1.91843 -16.5508 -5782 4 7.4491 13.1887 40.147 4.71488 4.53153 18.247 -5783 4 8.31974 13.1617 41.4819 -4.68073 -1.19795 -7.02436 -5784 6 9.95832 23.5973 1.60681 5.21402 2.49741 5.68021 -5785 4 10.4402 24.1882 0.998507 -5.12041 -6.82862 1.89989 -5786 4 9.65493 22.8254 1.1174 1.14228 -2.219 -8.51506 -5787 6 27.3184 14.1623 11.3341 -13.0256 18.3326 19.191 -5788 4 27.0532 14.8043 10.6617 -0.288735 -3.87647 -1.15481 -5789 4 27.1082 14.6278 12.1878 10.7132 -11.7932 -20.1286 -5790 6 25.8363 31.783 17.8928 12.257 -31.4953 -8.75538 -5791 4 26.5912 31.2312 17.6268 -16.3657 -3.28218 2.7807 -5792 4 26.257 32.5845 18.0942 8.13437 40.9862 10.9181 -5793 6 28.5106 34.3419 0.227626 33.3873 17.7784 12.057 -5794 4 28.9852 33.8482 0.904042 3.3493 0.859906 2.37016 -5795 4 27.7339 33.8559 0.0766936 -35.6263 -19.3635 -8.63216 -5796 6 39.4752 27.6784 22.7097 42.3367 15.2059 -23.9811 -5797 4 38.5679 27.9307 22.8105 -22.3645 11.7157 0.32019 -5798 4 39.9498 28.4084 22.1978 -16.9125 -22.6846 16.1018 -5799 6 19.4034 35.5119 37.6428 33.5095 -11.1022 16.798 -5800 4 18.7953 34.9333 37.2031 -16.031 -7.23993 -11.3762 -5801 4 20.0399 34.8524 38.0282 -15.2165 20.9239 -9.15559 -5802 6 40.2577 30.223 10.7322 40.2352 -13.6393 -47.8395 -5803 4 40.0003 30.153 11.624 -20.3139 3.96126 40.955 -5804 4 39.7054 30.7997 10.2038 -14.6911 14.5022 3.62333 -5805 6 44.8252 28.467 36.0943 -27.9317 -39.6182 20.2271 -5806 4 44.1 27.9067 36.617 42.0807 42.9759 -26.5645 -5807 4 44.8315 29.4044 36.3472 -5.71594 -8.07431 0.279077 -5808 6 17.9328 13.9421 34.2756 -23.0398 37.6904 -16.8553 -5809 4 17.2847 14.658 34.0723 21.6532 -14.16 -3.36915 -5810 4 17.4769 13.4978 34.9742 -2.33669 -21.4636 20.9706 -5811 6 22.7722 11.8049 25.9053 18.1639 13.4769 -8.32772 -5812 4 22.5143 10.954 26.1764 -32.0329 -27.8082 11.3637 -5813 4 23.7113 11.6387 25.939 19.9678 17.8754 -6.33473 -5814 6 27.9844 31.9785 40.3628 4.4159 -7.73511 16.6787 -5815 4 28.3104 32.752 39.9101 2.36742 5.81951 -9.83175 -5816 4 27.6866 31.3262 39.7216 -3.89657 2.92736 -3.90823 -5817 6 29.7056 5.13899 29.6966 36.1554 -28.1732 -9.81385 -5818 4 29.3242 5.52633 30.4675 -11.5775 13.5815 21.5043 -5819 4 30.5867 4.74321 29.9895 -34.1051 15.4003 -14.984 -5820 6 3.10893 21.4798 2.76501 -7.99866 -19.5262 -7.43282 -5821 4 2.82658 22.3873 2.73831 -4.86294 14.1814 1.21532 -5822 4 2.47005 21.0041 2.20282 6.80672 4.92349 5.4824 -5823 6 13.6497 30.6638 39.7451 -45.1888 -1.5 -27.4221 -5824 4 14.5316 30.8766 39.996 26.4643 7.88404 -4.33129 -5825 4 13.4124 30.9677 38.8135 13.6057 -6.06521 34.9266 -5826 6 39.188 23.0895 28.2562 15.2318 22.185 -40.3341 -5827 4 39.2961 23.1894 27.2636 -4.5014 -1.37473 28.8386 -5828 4 38.6302 22.3345 28.3879 -14.2617 -17.3372 5.24228 -5829 6 16.9988 23.7489 0.769214 20.7079 -15.4466 5.05665 -5830 4 16.2107 23.4786 1.24898 -3.68938 2.33828 -2.20359 -5831 4 17.6949 23.1909 1.19915 -10.9726 17.7258 -9.6056 -5832 6 0.328251 33.6592 13.0294 5.05621 13.0457 -18.8804 -5833 4 55.0348 32.9975 13.677 0.78154 12.2617 9.8199 -5834 4 0.388277 34.5816 13.3997 -6.36603 -34.6234 2.68168 -5835 6 49.1005 40.6595 16.9496 -9.76098 4.73909 -13.8177 -5836 4 49.2151 40.9775 16.0207 -4.23419 -6.48803 14.4163 -5837 4 48.1506 40.7848 17.1408 8.79948 2.71791 -6.65809 -5838 6 52.1337 39.9918 15.1756 26.7545 10.0433 -2.50902 -5839 4 51.9708 40.0067 16.1202 -6.38877 -4.81519 5.40892 -5840 4 51.3465 39.7494 14.7166 -22.4824 -4.17003 -7.64187 -5841 6 29.052 37.1033 37.836 19.097 -0.968932 -4.5801 -5842 4 29.682 36.5364 38.3049 -8.87198 1.40853 -5.4338 -5843 4 28.3717 37.2982 38.474 -12.8547 4.6316 9.68073 -5844 6 4.87585 1.47991 27.5772 1.0193 4.57332 -1.4391 -5845 4 5.21258 1.06654 26.7686 1.92757 2.57678 7.5628 -5846 4 5.62617 1.67061 28.1638 -3.61661 -2.55781 -2.1886 -5847 6 43.5959 24.3463 30.211 -19.7182 -5.92862 14.3815 -5848 4 44.3514 23.9347 29.8066 13.2495 -10.0411 -7.84874 -5849 4 42.954 23.6392 30.3929 6.93549 5.0637 -4.64144 -5850 6 33.7524 3.52358 22.9355 4.65558 -3.45748 -24.1115 -5851 4 34.2253 2.7722 22.5212 -9.10678 14.6802 11.3369 -5852 4 33.6063 4.18077 22.2154 2.29559 -11.8514 17.7295 -5853 6 19.8909 13.4517 25.3922 5.25873 -5.74859 -7.9771 -5854 4 20.5096 14.0736 25.7535 5.66529 16.002 2.33546 -5855 4 19.9521 12.7313 26.0185 -3.34295 -15.2779 0.0169051 -5856 6 47.3737 23.1767 39.6212 -5.95621 11.0118 4.46955 -5857 4 47.7191 22.5265 39.0041 4.75348 -8.18234 -7.77672 -5858 4 47.7813 24.0201 39.3891 1.84918 -0.94156 0.213564 -5859 6 20.1771 18.6734 32.3906 -2.68035 -24.6067 18.319 -5860 4 19.7167 19.3347 31.8914 0.274713 15.8779 -14.5216 -5861 4 21.1289 18.7867 32.3383 1.39014 4.37005 -4.23212 -5862 6 0.462706 5.80795 25.6713 -7.84599 -7.21428 -45.242 -5863 4 0.323825 6.56383 25.0471 7.25451 -11.4554 20.6165 -5864 4 0.632949 6.14438 26.5418 1.37183 20.4375 17.7538 -5865 6 6.87393 19.55 31.9207 -32.7339 30.668 -22.5905 -5866 4 6.24577 19.9891 32.5577 15.6688 -11.8235 -17.9631 -5867 4 6.64633 19.9665 31.0139 13.7505 -20.7976 33.8805 -5868 6 6.72837 20.2799 38.5105 -3.64262 3.78431 -13.5507 -5869 4 5.92588 20.8248 38.5086 9.85336 -2.70512 -1.72466 -5870 4 6.83039 19.9897 39.4188 -3.49896 1.12624 1.5432 -5871 6 22.0356 25.927 12.2605 -11.8373 -4.76705 -8.63625 -5872 4 21.2326 25.5939 11.7351 40.6868 7.42656 16.975 -5873 4 22.8707 25.497 11.9923 -13.8486 -7.11072 -10.1952 -5874 6 39.3057 7.93299 2.64755 -0.118713 9.42534 0.0803503 -5875 4 39.6638 8.10481 3.53463 2.86319 -1.68774 -0.268253 -5876 4 39.5974 7.06378 2.35963 5.09861 -8.7519 2.38745 -5877 6 29.9647 22.0457 34.4057 2.14844 7.25734 -28.1517 -5878 4 30.9338 21.915 34.3365 -18.2911 3.03872 -0.832433 -5879 4 29.6238 22.2503 33.4865 4.56359 -4.84177 28.516 -5880 6 37.5951 16.2788 0.369586 8.64826 -19.3515 -0.400608 -5881 4 37.1939 15.3927 0.526929 9.97291 14.3398 -5.3998 -5882 4 38.4404 16.082 41.8172 -10.5319 -0.823814 4.55326 -5883 6 11.7218 13.8845 21.8896 14.7882 -39.2126 -46.5495 -5884 4 11.9305 13.3995 21.0267 -7.58848 27.5443 23.8472 -5885 4 11.7147 13.1405 22.4934 -2.11531 -1.20748 18.2217 -5886 6 33.352 10.9238 27.6262 4.19409 14.5082 -21.7958 -5887 4 32.741 11.5866 27.2704 3.79692 -6.80494 8.02232 -5888 4 34.0591 10.8732 26.9373 -11.2958 -2.76298 18.1193 -5889 6 30.9422 36.5217 10.1011 0.546516 -38.0529 -7.53065 -5890 4 31.037 36.4313 9.10316 -3.7795 -1.86296 33.6151 -5891 4 30.9555 35.5897 10.5034 1.2522 32.9448 -19.5962 -5892 6 45.5828 6.56917 25.2425 13.4794 -38.3135 -0.0969536 -5893 4 44.6735 6.51564 25.4913 -20.1668 12.9455 3.79285 -5894 4 45.8221 5.605 25.2656 2.31227 28.4662 -4.04899 -5895 6 9.53612 30.0233 12.041 13.8898 -20.9008 -19.4413 -5896 4 9.92894 30.5763 11.3437 -1.97905 0.820167 2.98642 -5897 4 9.13364 30.6129 12.6538 -15.721 17.9312 16.9413 -5898 6 53.0747 24.9738 1.38132 -1.86355 2.7084 19.7503 -5899 4 52.7154 24.2509 0.898374 -13.0694 -24.4059 -9.99565 -5900 4 53.2522 25.5795 0.686793 9.94881 23.634 -11.856 -5901 6 26.1984 24.7352 0.509304 -7.53082 -0.727442 -26.3589 -5902 4 25.609 24.783 41.6367 17.1237 -12.5609 6.929 -5903 4 25.7967 25.3842 1.06587 -1.32139 13.3231 25.2347 -5904 6 23.0109 2.41889 11.5345 -1.81733 -0.917938 -19.7561 -5905 4 22.156 2.16845 11.9124 1.98231 0.963836 1.10425 -5906 4 22.831 2.471 10.5696 1.38956 0.195961 11.1121 -5907 6 29.9165 12.8947 31.0013 41.0722 8.15666 -12.068 -5908 4 30.8272 12.8901 31.3843 -23.6061 -3.22469 3.62361 -5909 4 30.1671 13.0589 30.0659 -21.5099 -4.3955 11.2257 -5910 6 24.0423 16.1922 40.3682 -11.7161 -52.7791 -12.7633 -5911 4 23.7963 16.7427 41.0863 -4.03022 37.1909 22.8519 -5912 4 24.4513 16.6836 39.6566 3.29428 17.0417 2.56802 -5913 6 21.8759 29.9137 12.7377 16.7673 9.38207 5.68416 -5914 4 21.0615 29.603 12.3447 -12.732 2.54077 -5.12984 -5915 4 21.8572 30.8889 12.7388 -3.49843 -10.2696 0.0943897 -5916 6 45.2049 12.2865 6.6319 2.92472 30.2037 5.62675 -5917 4 45.4908 11.5347 6.14771 0.0808414 -27.1796 -10.0093 -5918 4 45.9331 12.9133 6.49804 -8.49251 3.31449 4.74769 -5919 6 7.58748 25.3948 38.035 37.4402 -5.69153 16.1754 -5920 4 8.20159 25.1941 37.2709 -20.479 6.14302 24.9331 -5921 4 8.13335 25.2556 38.8857 -20.6102 5.92378 -35.7711 -5922 6 46.1732 7.83303 16.6988 4.4841 14.5494 -17.535 -5923 4 46.5452 7.84101 15.8027 -9.24205 10.2202 -0.760543 -5924 4 46.6945 7.14485 17.0776 9.771 -19.5689 22.069 -5925 6 54.9675 12.85 7.71106 -14.5426 11.3809 9.40253 -5926 4 54.9732 13.8139 7.75484 8.59467 -0.566973 -8.90089 -5927 4 54.3786 12.658 8.45528 8.25441 -10.7611 -5.52346 -5928 6 26.93 39.6729 37.1759 35.4319 -17.0193 24.0328 -5929 4 27.7049 39.4447 36.6239 -16.3058 8.04164 -6.8945 -5930 4 27.2164 39.2553 38.0316 -23.1866 12.5553 -17.3208 -5931 6 27.0277 8.92497 38.0115 25.8258 -15.1538 -19.4143 -5932 4 26.3205 9.53863 38.1727 -14.2244 17.8778 -0.0983549 -5933 4 27.5327 9.26244 37.2322 -14.307 -2.33761 14.5508 -5934 6 8.04621 7.65921 29.9125 5.96085 -8.8046 12.0925 -5935 4 8.66182 7.92407 30.6202 -6.26406 -0.422529 -8.96361 -5936 4 7.80891 8.46925 29.4702 -0.676119 14.2 -7.80782 -5937 6 27.8751 27.8625 12.1001 -31.3933 22.4686 19.454 -5938 4 27.5095 28.719 12.4446 7.36494 -19.3603 -4.77408 -5939 4 28.6439 28.079 11.5991 25.5597 3.40516 -15.3306 -5940 6 23.5464 30.4867 38.1533 -1.61625 -6.62341 9.61758 -5941 4 24.0833 30.8354 38.8715 -5.37174 -4.61911 9.80189 -5942 4 23.9933 30.8636 37.4157 3.53805 3.96797 -22.0348 -5943 6 48.0805 24.2983 17.323 -13.282 16.609 -1.2587 -5944 4 47.4189 24.8263 17.8481 20.4082 -10.1323 -14.146 -5945 4 48.1392 24.7467 16.448 -1.93384 -6.90404 13.1726 -5946 6 38.5137 5.30503 40.3397 -7.95418 19.3032 15.6478 -5947 4 38.8605 4.51762 39.8919 14.9068 5.60332 0.485922 -5948 4 39.0782 6.12858 40.3573 -2.94219 -25.5867 -8.28862 -5949 6 31.2334 3.92786 33.7298 9.31662 9.08835 -13.8199 -5950 4 31.8178 4.24357 33.0198 -6.00608 1.6224 5.38661 -5951 4 31.5957 3.05883 33.9262 -1.57661 -10.2527 7.73336 -5952 6 41.2417 8.81323 38.1247 -0.484904 -12.0607 11.4744 -5953 4 40.9476 8.42023 38.9721 -0.376638 9.54125 -7.13918 -5954 4 41.2604 9.77162 38.2616 1.58028 -2.03482 4.89657 -5955 6 53.3602 29.1001 24.587 -11.0956 7.72569 2.80506 -5956 4 52.5731 28.5594 24.8544 13.5868 20.3826 -7.54714 -5957 4 53.0545 29.9696 24.221 1.09296 -21.6534 7.27768 -5958 6 54.9204 15.5334 40.7094 -9.73888 -15.8123 9.62316 -5959 4 54.8689 16.4143 40.4003 18.499 35.235 -15.9181 -5960 4 53.9936 15.418 40.9228 -4.36807 -19.1537 6.40504 -5961 6 46.4046 17.0769 31.8825 -4.88415 8.61979 -0.317809 -5962 4 46.5643 17.9902 31.5503 -4.54791 -14.0743 0.407713 -5963 4 45.6863 16.6828 31.3336 12.87 12.2001 8.08584 -5964 6 36.9136 25.0502 23.0508 4.56287 5.14957 -21.3849 -5965 4 37.1181 25.0639 23.9643 8.53293 7.7605 31.6671 -5966 4 36.2092 24.4176 22.9617 -10.0712 -5.98832 -5.36051 -5967 6 11.3786 4.43396 15.9309 9.37238 17.2608 -3.05203 -5968 4 11.3458 3.5794 15.4688 2.43716 9.1998 0.97888 -5969 4 11.7026 5.12247 15.2999 -5.70859 -16.4138 5.77914 -5970 6 12.7896 7.06818 19.4525 -2.66824 36.6483 10.7184 -5971 4 12.9865 6.29411 18.9417 0.495259 -24.323 -4.17525 -5972 4 12.2519 6.828 20.2299 7.04203 -8.59773 -13.3487 -5973 6 12.0617 33.6499 17.5439 8.15138 -13.8576 -23.5514 -5974 4 11.882 34.0654 18.3682 -11.1792 16.7137 24.4072 -5975 4 12.5902 32.8825 17.8108 -1.08307 -0.300652 -3.52071 -5976 6 10.2421 4.75805 2.56564 19.3085 -11.8452 1.86691 -5977 4 9.45693 4.42703 2.99801 -10.4664 -1.42643 2.59081 -5978 4 10.9264 4.04527 2.68225 -6.18235 16.1727 -3.70264 -5979 6 4.57251 36.8735 12.1563 3.74049 -23.6741 -21.1206 -5980 4 4.47996 37.7154 12.5491 -11.9533 34.2042 20.255 -5981 4 5.43811 36.9355 11.7449 0.921031 -10.3689 -0.351167 -5982 6 30.7412 35.3317 25.8213 -33.1423 -23.543 6.44877 -5983 4 31.2776 35.279 26.6136 10.5944 3.70967 -1.00248 -5984 4 29.9668 34.7615 26.0677 13.1622 11.7399 -12.7178 -5985 6 20.1808 7.16217 1.863 30.1084 16.4868 -11.867 -5986 4 20.9002 6.54767 2.16414 -16.0511 17.5979 -8.58506 -5987 4 20.6676 7.94845 1.45686 -14.4541 -29.1822 13.3394 -5988 6 21.7608 6.89709 28.9964 -11.5861 -1.80466 -8.03013 -5989 4 22.036 7.16072 29.8728 6.26891 1.69864 13.9065 -5990 4 22.5393 6.5849 28.5353 8.83449 0.101288 -1.59126 -5991 6 6.87368 37.1369 6.9386 0.0966708 26.3677 27.0276 -5992 4 7.29364 38.0249 6.81033 -7.58004 -19.2864 -7.26696 -5993 4 6.61926 37.1727 7.88431 1.83825 -7.02501 -19.6681 -5994 6 37.1919 18.383 16.2937 29.0289 34.5069 -53.2335 -5995 4 36.6258 18.6038 17.011 -19.1901 14.6481 22.2869 -5996 4 37.3395 19.2625 15.7718 -11.4936 -34.1346 27.3139 -5997 6 52.3871 25.4845 31.3088 43.0013 26.9533 24.6388 -5998 4 52.3889 26.4071 31.692 -12.9868 -26.5619 -15.078 -5999 4 53.3562 25.2868 31.368 -25.5563 -9.18093 -7.26498 -6000 6 3.9438 39.8542 16.3866 5.1752 -27.5036 1.27902 -6001 4 3.12325 39.6837 16.8533 -2.95342 6.97088 0.658243 -6002 4 4.2268 38.9387 16.1321 1.7457 31.291 -0.663648 -6003 6 26.0576 14.6358 18.3044 5.96149 26.4073 -5.45028 -6004 4 27.0205 14.6227 18.4365 -6.17521 2.0803 0.6884 -6005 4 25.8163 15.5963 18.2277 1.60591 -22.5499 1.70317 -6006 6 22.193 39.6312 23.63 -9.05536 -28.9999 9.83005 -6007 4 22.6639 40.3889 23.3083 10.2118 22.7493 1.36107 -6008 4 21.7625 39.8434 24.4837 8.53947 8.47814 -10.8223 -6009 6 5.99591 12.8758 22.3742 5.3436 -0.661706 -0.190442 -6010 4 6.14325 13.1833 21.4713 -0.679137 1.38292 -0.893953 -6011 4 6.87425 12.6139 22.6767 3.78948 -2.07704 1.05968 -6012 6 48.9338 28.1628 34.7078 -35.8712 26.2385 4.15493 -6013 4 48.201 27.5556 34.4701 19.6025 -0.265843 1.21851 -6014 4 49.8217 27.8183 34.7001 12.2446 -20.4038 -3.75147 -6015 6 7.76997 22.4407 33.2353 -5.03116 -11.9457 7.57841 -6016 4 8.01899 22.0009 34.0594 5.33952 7.11928 -2.86974 -6017 4 7.10669 21.8538 32.8613 -1.17853 4.26119 -2.40878 -6018 6 41.0955 39.6222 11.7091 10.6381 -27.5326 3.52715 -6019 4 40.5189 40.2602 11.288 0.0449404 21.7474 -0.525631 -6020 4 41.8612 39.9918 12.1934 -14.1016 15.1893 -9.59654 -6021 6 26.8828 37.915 39.359 -2.28209 0.567193 11.8658 -6022 4 27.0774 38.1179 40.3058 -8.7685 -4.90824 -13.677 -6023 4 25.9807 37.5277 39.3071 12.6176 5.79057 5.20946 -6024 6 16.8333 41.5427 16.7885 -17.5694 -7.84814 -1.75502 -6025 4 17.5277 0.148354 16.3589 5.69783 -2.62712 11.3029 -6026 4 16.9979 41.3393 17.726 8.37907 5.88226 -10.2657 -6027 6 19.018 8.99657 17.6669 -0.857073 -13.2853 32.8939 -6028 4 18.786 9.90902 17.9004 1.19423 -0.949069 -3.8378 -6029 4 19.1413 8.47286 18.5173 -2.13518 15.132 -32.6231 -6030 6 31.1034 24.3848 20.0884 -4.53251 11.7336 -2.81937 -6031 4 30.5766 24.6463 20.8643 6.13742 -4.20791 -6.36966 -6032 4 31.7352 25.0989 19.9557 0.422515 0.146513 0.562515 -6033 6 24.595 6.30881 27.6069 -9.90555 -11.0232 -14.6341 -6034 4 24.6965 6.6392 26.7007 0.89989 8.76246 8.56835 -6035 4 24.5083 5.35606 27.4824 0.344086 -1.65377 9.53776 -6036 6 11.6335 5.32908 8.21523 29.3959 14.5761 -12.3078 -6037 4 10.744 5.12885 8.4339 -32.4949 -9.42488 11.9016 -6038 4 11.5648 6.10082 7.62627 0.276207 -9.77668 5.48929 -6039 6 16.478 34.2375 17.2464 48.0037 -1.61779 7.84119 -6040 4 15.7306 34.6529 16.8034 2.48832 11.605 -8.49411 -6041 4 17.405 34.6677 17.061 -56.7063 -17.2336 2.19282 -6042 6 40.7477 40.4696 8.51561 8.11488 -8.65224 -15.2287 -6043 4 40.0224 40.6832 9.09702 -8.50867 2.70994 6.70857 -6044 4 40.4514 39.6579 8.0617 2.3787 8.8385 5.97324 -6045 6 42.7444 5.87231 14.2984 24.2128 7.61876 -1.56509 -6046 4 42.0757 5.96647 14.9632 -14.4615 -1.80987 8.42029 -6047 4 42.482 5.17586 13.6922 -11.2697 -3.69634 -0.0191913 -6048 6 14.3614 21.0573 6.06698 -40.3301 2.02826 20.3099 -6049 4 14.5082 21.6099 6.85229 1.25225 -5.13952 -5.68983 -6050 4 15.1941 20.9025 5.67555 35.2665 -1.55979 -15.977 -6051 6 16.3015 37.7733 18.121 -25.7671 9.10936 -15.4408 -6052 4 15.381 38.1761 18.2458 41.2545 -15.1679 7.93486 -6053 4 16.7788 37.6858 18.9587 -11.1023 5.71932 1.62274 -6054 6 40.7984 27.7161 27.1129 -11.0179 0.499807 -0.336913 -6055 4 41.4742 27.2927 27.66 5.56711 1.79851 -1.75817 -6056 4 41.2133 28.334 26.4954 6.67104 -1.0644 4.19578 -6057 6 44.9561 25.991 14.0487 25.7727 -16.7938 -19.0088 -6058 4 45.3739 25.1637 13.7108 -16.5098 12.8855 15.8726 -6059 4 45.5476 26.6442 13.6478 -7.0093 2.51014 3.36733 -6060 6 2.61494 33.9473 21.2474 -9.6198 2.06317 -4.83635 -6061 4 2.13704 34.7904 21.3802 4.44423 -7.12162 -0.559399 -6062 4 2.10703 33.4352 20.5879 2.52794 8.8644 7.26413 -6063 6 5.77575 4.45209 12.8318 1.03208 18.7287 8.08797 -6064 4 5.35339 3.69685 13.2518 -3.06112 -10.1665 -2.69945 -6065 4 5.8052 5.15326 13.507 0.887863 -7.02627 -5.52828 -6066 6 16.8649 5.92112 7.40874 19.9951 -5.29142 4.66315 -6067 4 16.4994 5.07825 7.12483 -4.58221 -9.71617 -5.56506 -6068 4 16.109 6.48147 7.52662 -16.4719 8.95214 3.19539 -6069 6 17.8298 38.4233 36.8534 9.258 40.3096 -0.310058 -6070 4 17.7926 39.4131 36.8935 -6.04129 -19.7424 1.84578 -6071 4 18.5177 38.2893 36.201 1.93535 -10.8086 -1.92368 -6072 6 43.3019 20.5959 5.44166 -6.9278 5.85438 -3.52603 -6073 4 43.1055 21.501 5.07158 -2.97833 -26.833 8.04502 -6074 4 42.4661 20.0651 5.41852 11.3272 16.2867 -2.99003 -6075 6 21.5372 23.2991 30.4448 -14.935 11.2275 -26.3705 -6076 4 20.9947 23.0537 31.1809 -7.12546 -6.28648 20.8256 -6077 4 20.8648 23.582 29.7655 22.6032 -4.28693 10.3415 -6078 6 0.251317 28.0486 36.1651 -22.0243 21.0356 -19.5016 -6079 4 1.02049 27.7114 36.6113 18.9729 -1.47718 6.47801 -6080 4 0.506474 28.8456 35.6445 2.58205 -12.8812 9.00708 -6081 6 3.04678 17.0589 11.5707 1.23946 -7.00965 -18.5436 -6082 4 3.14519 17.2619 12.4977 -1.89892 8.1653 13.6088 -6083 4 2.54959 17.7766 11.1613 1.73961 1.36316 5.23635 -6084 6 24.1645 37.0333 23.9496 -13.0802 10.7124 17.6799 -6085 4 23.6099 37.8384 23.8849 6.1763 -9.33563 -1.28122 -6086 4 24.4663 37.0147 24.8893 -3.58635 -1.49958 -18.3056 -6087 6 3.94341 20.5209 27.4789 6.12038 36.4957 26.1587 -6088 4 3.64002 20.0757 26.7101 -13.0247 -10.3927 -30.3524 -6089 4 3.8213 21.4921 27.3096 0.6263 -21.942 -1.90407 -6090 6 54.8381 2.78983 29.6272 25.3782 12.002 29.7256 -6091 4 54.8259 2.49183 30.5832 -3.08894 8.50949 -25.0172 -6092 4 0.681738 3.33643 29.5869 -23.0163 -14.7319 0.890579 -6093 6 27.1738 8.43221 31.7209 4.37325 44.8318 10.1666 -6094 4 26.7765 8.21235 30.8513 3.34031 12.9925 0.247925 -6095 4 27.4394 9.43578 31.8184 -18.7706 -51.1708 -12.8964 -6096 6 30.9422 1.62815 30.3909 7.68258 9.19266 14.5116 -6097 4 30.6848 0.902997 29.8247 -17.6873 -14.6962 -9.63211 -6098 4 30.1385 1.96768 30.8202 -2.70664 -9.08975 -4.26502 -6099 6 26.4126 36.4396 36.8407 14.7094 2.78685 2.16538 -6100 4 26.1754 35.936 36.0621 -1.37556 -1.6634 -9.1832 -6101 4 27.3614 36.6667 36.7609 -11.9856 -2.56278 0.470716 -6102 6 51.3051 10.055 21.7064 16.9271 -12.7171 -0.47742 -6103 4 50.71 9.38094 22.0984 13.3581 11.7028 -6.50503 -6104 4 52.1297 9.58932 21.3894 -28.6693 12.5934 9.83408 -6105 6 52.4269 12.3712 23.2743 -6.4707 23.0639 13.1163 -6106 4 51.7645 13.1043 23.2119 13.6159 -11.3613 1.42096 -6107 4 52.024 11.6223 22.842 -6.69009 -13.0182 -9.76131 -6108 6 10.0084 38.37 20.6075 21.9453 -2.41338 -4.30271 -6109 4 9.45069 38.2813 21.3825 -6.19229 -0.201962 6.85596 -6110 4 10.9137 38.1225 20.8794 -8.5598 0.614521 -3.9406 -6111 6 22.7031 33.2664 0.640708 10.9794 6.62646 4.85135 -6112 4 23.6679 33.2996 0.582378 1.56947 7.5672 2.73741 -6113 4 22.5144 32.4288 0.230474 -14.5468 -15.5809 -6.04383 -6114 6 14.0917 40.8812 25.4864 9.18744 8.89463 -14.7226 -6115 4 14.196 40.6884 26.4283 -5.63746 -5.20078 0.271339 -6116 4 13.2439 40.5125 25.1796 5.27736 1.6069 9.18822 -6117 6 42.7681 15.0783 14.9763 7.15748 5.71054 -2.59845 -6118 4 43.0785 15.7158 14.2901 -5.10451 -16.9901 16.8665 -6119 4 41.8327 15.2592 15.1092 -5.54173 -0.124331 1.80857 -6120 6 30.2406 7.22111 8.53832 -0.545825 26.9265 -4.64375 -6121 4 30.1758 8.19473 8.52708 -1.1145 -9.52086 -16.9196 -6122 4 30.4024 7.07989 9.45321 5.06633 -17.0605 24.2519 -6123 6 3.37759 19.8423 41.3077 23.4194 0.89426 -0.123069 -6124 4 3.19865 19.3681 40.4829 0.842743 3.23829 1.04749 -6125 4 4.34953 20.0012 41.2688 -20.407 -4.57585 2.1738 -6126 6 8.87423 25.1354 17.2017 -10.0567 -4.23249 -18.7298 -6127 4 8.96932 24.947 16.2256 5.94886 2.92938 28.6011 -6128 4 9.65182 24.8278 17.6915 0.0257745 -5.63434 -9.64419 -6129 6 9.32494 14.9555 22.0283 -12.5325 4.5599 7.62514 -6130 4 9.01993 14.8718 22.9489 -0.27625 1.365 -7.1979 -6131 4 10.1958 14.5523 22.0148 2.38734 -2.44115 -2.54227 -6132 6 2.03086 4.7751 20.8592 -0.302533 -25.5342 -8.8148 -6133 4 2.76807 5.37577 20.9697 7.90436 11.3601 5.00545 -6134 4 1.2576 5.15949 21.2703 -7.54078 11.376 6.7073 -6135 6 18.2964 7.06718 3.86051 -0.633466 1.54328 39.8902 -6136 4 18.916 7.22135 3.16498 20.2468 5.35447 -22.1173 -6137 4 18.8081 6.54637 4.52758 -12.8964 10.087 -8.61721 -6138 6 17.0178 19.1734 19.8425 8.05121 8.342 4.19715 -6139 4 17.786 18.9037 19.3194 -9.06534 -4.96345 -2.22737 -6140 4 16.269 18.585 19.6427 11.1227 0.819232 -3.01639 -6141 6 4.30363 6.55267 21.3463 7.67654 -0.43578 -3.38259 -6142 4 4.33009 7.06923 20.5107 4.36212 -5.74714 10.2686 -6143 4 5.22777 6.26626 21.5669 -20.6993 9.2157 -12.5452 -6144 6 20.7848 36.9284 35.662 4.03453 1.95325 3.7669 -6145 4 20.2254 37.0836 34.8976 -2.25577 1.87165 -3.27163 -6146 4 20.2383 36.4327 36.2875 0.848364 -0.11832 4.44878 -6147 6 4.7306 15.0205 31.2333 -1.91968 -20.8619 8.65585 -6148 4 4.4229 14.7734 32.1398 6.18773 10.2906 -17.1472 -6149 4 4.73385 15.973 31.1263 -2.35963 8.87481 4.31723 -6150 6 2.35358 1.22877 17.5767 10.9459 -8.92502 -6.22121 -6151 4 3.05741 1.28614 16.8672 -19.772 5.07478 19.7417 -6152 4 1.94409 2.09607 17.7592 7.86728 -5.07336 -5.26938 -6153 6 34.6221 31.5613 19.8029 0.0167231 -1.91103 -0.857839 -6154 4 35.0026 31.8698 18.9629 1.12657 -3.13716 4.28436 -6155 4 34.4223 32.3623 20.3103 -0.485441 0.265221 -3.01806 -6156 6 24.1912 21.6103 13.5173 31.6251 8.72647 13.7111 -6157 4 25.0921 21.8731 13.8418 -25.6554 -7.43575 -12.369 -6158 4 23.5893 22.1875 13.984 -2.65104 7.77201 2.87587 -6159 6 37.2187 41.0834 5.69361 1.76676 -13.0415 -0.936073 -6160 4 37.8761 41.7354 5.91144 16.7665 3.57334 0.125879 -6161 4 36.4089 41.5349 5.88363 -19.4064 5.82624 -1.33385 -6162 6 8.4323 8.00063 20.2395 28.2224 -17.334 -6.20124 -6163 4 9.29892 8.115 20.6547 2.73811 -3.60152 -0.447724 -6164 4 7.94828 8.69862 20.6224 -29.3938 29.4062 12.6481 -6165 6 14.9357 18.8843 36.7618 11.8158 33.7978 0.271425 -6166 4 14.1259 19.2123 36.362 -3.40669 -6.42507 -0.135577 -6167 4 15.5651 19.6361 36.6422 -7.52364 -17.7077 5.06346 -6168 6 43.9725 40.6444 18.6569 4.16672 -2.33153 16.0012 -6169 4 43.9166 40.834 17.7203 0.682613 4.51617 -13.4207 -6170 4 44.9212 40.6761 18.9032 -12.0211 -3.47257 -3.21486 -6171 6 33.7852 32.2494 37.3449 -11.8504 2.76306 -14.1758 -6172 4 34.0177 32.2775 36.4055 -1.41242 -0.232407 11.1732 -6173 4 34.3686 31.6236 37.7745 10.7747 -2.06792 3.13276 -6174 6 5.09749 29.2901 24.0356 16.7213 -6.5526 19.7529 -6175 4 5.77222 29.487 24.7328 -11.5239 -2.29901 -14.2657 -6176 4 4.7684 30.1321 23.7215 -1.73734 11.0072 -2.10513 -6177 6 33.6153 36.4198 10.9805 1.47517 3.52666 5.33615 -6178 4 32.7579 36.4403 10.5596 -3.06779 3.10292 -7.60642 -6179 4 33.384 36.4828 11.91 5.71512 -0.747971 7.16991 -6180 6 28.3006 33.5952 13.1115 6.62888 -15.4249 13.7129 -6181 4 27.948 33.7778 12.2398 -4.56551 -8.24283 -4.77521 -6182 4 28.1705 32.6462 13.2914 -0.364449 12.3294 -7.26248 -6183 6 6.16378 19.058 24.2919 3.99573 -9.29146 -27.7059 -6184 4 6.01812 19.825 24.8144 -3.49512 27.1397 16.8881 -6185 4 6.29927 18.3335 24.8859 3.7649 -20.2974 16.0908 -6186 6 28.4267 19.9356 1.8581 6.30761 1.98196 1.30153 -6187 4 28.5945 19.3745 1.10227 -2.74725 -9.675 -9.29711 -6188 4 29.2893 20.1184 2.23075 1.76934 5.71608 2.57016 -6189 6 42.0557 23.969 9.55925 -0.174378 -1.97525 4.49576 -6190 4 42.3037 23.8044 10.4694 5.92504 9.79373 11.5418 -6191 4 41.7282 23.1152 9.29053 -8.19873 -12.6145 -11.7634 -6192 6 43.5187 7.30226 27.4319 7.08124 -12.3985 0.368771 -6193 4 42.7424 7.14751 27.9838 -5.23639 1.01312 3.8871 -6194 4 43.2552 7.97753 26.8025 -4.71413 8.37143 -8.21745 -6195 6 20.4824 33.0041 9.27291 -32.573 -27.3267 34.6611 -6196 4 19.7824 32.5876 9.93875 35.2414 32.5831 -36.6535 -6197 4 20.3431 33.9616 9.1663 -10.2228 -2.75758 9.24016 -6198 6 38.0326 35.2526 15.9362 -7.94884 -19.6622 -5.99631 -6199 4 37.3459 34.9971 15.2894 4.63074 2.95951 5.93375 -6200 4 37.9463 34.6017 16.6504 2.45283 5.99568 -2.76115 -6201 6 47.5301 20.8853 3.96175 -5.34824 -5.66637 20.3565 -6202 4 47.9759 21.3648 3.2498 -4.9297 7.97101 8.48596 -6203 4 47.5029 21.3928 4.81786 6.75175 -1.3172 -26.6206 -6204 6 10.9933 31.6966 41.4271 11.47 5.02521 -0.853614 -6205 4 11.6392 31.7665 40.7132 0.112137 -5.28149 3.10577 -6206 4 10.1353 31.6993 40.998 -8.62143 -0.203152 -1.66696 -6207 6 43.2403 12.6562 2.57215 9.62694 -8.68348 -18.5989 -6208 4 42.9077 12.993 3.39384 -2.38679 2.43178 19.528 -6209 4 44.033 12.1261 2.78242 -8.9232 8.2725 3.71991 -6210 6 49.4204 25.4105 21.1683 5.59269 -12.2048 -2.72561 -6211 4 50.0196 25.2987 20.4097 -7.64964 4.29225 2.01473 -6212 4 48.8877 24.5919 21.195 1.69169 7.44836 1.02425 -6213 6 1.95674 34.1403 26.4747 8.8762 -24.2704 6.47661 -6214 4 2.77674 33.6103 26.5537 -12.4269 14.6955 -4.62849 -6215 4 1.26657 33.4613 26.3994 -1.21739 9.31774 -1.03397 -6216 6 17.1306 20.8229 36.6851 -31.9931 14.1441 13.8122 -6217 4 16.9533 21.7471 36.9985 5.62896 -19.6931 -5.93312 -6218 4 18.0634 20.696 36.5868 23.783 -2.64609 -3.70934 -6219 6 36.6048 10.9866 3.71548 -5.44552 8.31799 24.2539 -6220 4 35.7423 11.3886 3.87785 -5.6936 5.55042 -13.8219 -6221 4 36.8135 10.7077 4.61447 10.9535 -7.59336 -0.361553 -6222 6 14.2169 20.6838 21.9439 11.6961 23.12 -6.3106 -6223 4 13.8085 20.2376 21.1912 1.98746 8.13024 -7.83415 -6224 4 14.8103 21.4259 21.6461 -14.674 -27.097 -1.82439 -6225 6 33.9151 12.2544 9.54899 39.8857 -26.0408 -21.0892 -6226 4 34.3088 11.5163 10.0208 11.0461 -3.70138 -11.6499 -6227 4 33.2997 12.4814 10.1903 -47.9458 31.9244 32.2008 -6228 6 21.8056 41.4836 2.15686 0.64336 -1.87746 -8.80618 -6229 4 22.0354 41.6672 1.22189 -5.57638 1.91412 12.8342 -6230 4 22.5122 40.9391 2.50884 5.16687 -0.375256 0.644554 -6231 6 20.9282 10.4547 14.1996 25.019 -0.0729632 25.5582 -6232 4 21.5922 10.842 14.8375 -21.0894 -6.80718 -21.5316 -6233 4 20.826 9.54084 14.5456 -0.887825 12.9084 -9.51249 -6234 6 6.24616 4.45231 24.6293 -10.9468 0.993291 2.39826 -6235 4 6.83688 4.17894 23.9311 12.242 -0.137787 -14.9911 -6236 4 5.68087 3.68408 24.7586 -3.59028 -1.51582 -1.5433 -6237 6 50.784 14.5954 23.4824 21.8736 9.84292 5.60122 -6238 4 51.2681 15.1205 24.1582 -9.03857 -7.6656 -10.4761 -6239 4 49.9341 14.3608 23.8519 -7.60536 -4.54693 6.65168 -6240 6 52.7678 13.9144 9.68214 -3.90955 36.1598 -0.40974 -6241 4 52.8738 13.0144 9.92216 4.47335 -34.5538 7.53363 -6242 4 51.8729 14.0092 9.35938 -14.036 0.105332 -6.17221 -6243 6 9.05048 2.05234 29.9152 -29.3842 -12.1538 -14.6176 -6244 4 9.42756 2.83336 30.2687 13.3628 24.1087 13.7335 -6245 4 8.09173 2.26823 29.8032 18.9866 -6.39081 0.174186 -6246 6 7.13499 29.9757 26.2377 7.52656 -33.046 2.78556 -6247 4 6.52748 30.39 26.8607 -0.20976 -1.88395 4.87081 -6248 4 7.49713 29.1538 26.6869 -11.4544 24.9502 -11.4644 -6249 6 49.1541 41.742 14.3355 11.4439 21.5488 -10.6063 -6250 4 49.5333 41.2573 13.5835 -2.72613 -5.13007 3.47372 -6251 4 49.526 0.750494 14.2401 -8.50163 -23.9907 2.80869 -6252 6 5.64545 3.82333 19.1929 -5.43924 -10.1162 19.2647 -6253 4 5.12472 3.39384 19.906 6.51959 7.46947 -11.8792 -6254 4 5.07872 3.8651 18.4273 -3.31865 2.78603 -7.74707 -6255 6 9.32747 35.8381 24.9081 -3.67476 7.0144 6.61099 -6256 4 10.2167 35.7622 24.5243 -1.5306 1.39279 3.84516 -6257 4 9.42305 36.4736 25.6393 1.10498 -0.920313 -3.33942 -6258 6 53.0258 29.7567 11.5493 -1.29773 -2.97991 8.71205 -6259 4 53.4398 30.4104 10.9769 2.6525 4.63524 -3.89524 -6260 4 52.8324 30.2122 12.386 1.27544 -1.91261 -4.55584 -6261 6 22.6082 9.97702 5.69106 1.45951 -2.04334 43.7981 -6262 4 23.4598 10.2484 6.09617 -7.85329 -3.83944 -13.5574 -6263 4 22.5497 10.2693 4.79236 2.60512 5.60546 -21.7219 -6264 6 39.5532 19.6216 2.68726 -3.50035 -14.5445 -22.3968 -6265 4 38.6563 19.3067 2.54039 -1.65167 0.121811 17.9309 -6266 4 39.9003 19.405 1.80953 18.3116 7.78412 6.67062 -6267 6 45.082 35.5833 7.81025 20.3465 -2.3491 -25.2688 -6268 4 45.1219 36.3229 8.40611 -5.73741 11.9797 15.8104 -6269 4 44.452 34.9332 8.12016 -12.4923 -3.86067 9.83054 -6270 6 29.7976 14.244 9.96067 -5.32248 -4.64296 1.12628 -6271 4 30.0443 14.0971 9.02808 -4.18819 -1.64606 2.67632 -6272 4 28.8444 14.0269 10.0606 18.5465 4.64021 -4.02524 -6273 6 29.2523 30.155 21.8932 -5.77992 6.30922 3.94049 -6274 4 29.1431 30.8143 21.21 -7.42967 10.4849 -3.0507 -6275 4 30.0153 29.6632 21.6201 11.6336 -14.2167 -2.13367 -6276 6 11.1107 18.8213 6.56056 -14.6836 -1.88929 0.635516 -6277 4 11.166 19.7501 6.27543 7.98891 -2.6539 -0.194038 -6278 4 11.9915 18.4225 6.59495 6.41359 9.14832 -2.51569 -6279 6 13.4142 39.1371 13.4638 17.7807 -10.3765 -23.6259 -6280 4 13.7831 39.7975 14.0449 5.16656 9.87024 9.85065 -6281 4 12.6066 38.8468 13.8734 -16.0883 -5.26763 6.93978 -6282 6 50.1521 12.9948 0.13749 23.7903 11.3983 42.7862 -6283 4 49.8531 12.6437 41.2486 -17.3674 -16.2897 -43.7514 -6284 4 50.6811 12.2823 0.528204 -2.61001 5.26075 1.59628 -6285 6 47.8279 31.3538 27.7873 0.535952 -14.579 -21.2406 -6286 4 47.8981 31.8966 28.5732 -11.876 9.28639 5.42067 -6287 4 46.9879 31.5201 27.3031 12.1261 3.81279 14.9113 -6288 6 27.708 1.63283 7.49454 14.1634 -3.44528 -21.3886 -6289 4 26.9442 1.71926 8.04828 -16.4795 3.87106 10.0363 -6290 4 27.4331 1.03137 6.77318 -2.44435 3.14912 6.58235 -6291 6 54.8843 20.7912 16.041 -0.591057 -23.5277 -19.4313 -6292 4 54.9506 20.9946 16.9763 2.49267 -3.51754 11.2958 -6293 4 0.215527 19.8591 15.8725 -6.64294 24.8159 10.1677 -6294 6 37.4309 32.9919 34.4461 -3.01999 17.5498 0.613574 -6295 4 37.2599 32.074 34.6492 -8.98721 -14.1314 1.69718 -6296 4 36.602 33.3843 34.0789 10.8556 -9.90957 7.57788 -6297 6 19.516 39.775 6.74949 1.2991 -23.719 -0.568837 -6298 4 19.1628 39.2461 5.9771 11.6696 10.1577 21.4746 -6299 4 19.8715 39.1258 7.41882 -10.6166 14.587 -19.1486 -6300 6 32.439 2.74298 8.0597 2.15016 14.1028 28.0311 -6301 4 32.8474 3.04427 8.91221 -2.20578 -4.83758 -21.9226 -6302 4 31.6043 2.37221 8.38063 -2.27075 -4.50389 -9.9889 -6303 6 12.9757 16.0783 4.05517 0.782156 -17.4841 -11.0101 -6304 4 12.5393 15.6612 4.81952 2.97976 0.136191 -5.67644 -6305 4 13.3707 15.3387 3.55371 -3.64889 7.0956 8.52646 -6306 6 4.65115 29.9533 5.41887 4.80886 14.2508 -32.4371 -6307 4 5.0407 30.2031 4.52094 -17.5959 -12.1853 28.663 -6308 4 3.95879 29.263 5.26663 23.43 17.9812 0.878069 -6309 6 29.754 32.1152 24.0535 7.2798 7.01713 3.37681 -6310 4 30.6602 32.1649 24.4187 -11.1956 -0.828668 -6.39664 -6311 4 29.7572 31.4388 23.3746 -2.03067 -7.97912 -3.55015 -6312 6 11.8649 30.6972 33.4692 4.66278 -43.8766 26.3819 -6313 4 11.8723 29.8544 34.0435 -6.78391 38.5593 -23.2698 -6314 4 12.7601 30.7129 33.1118 -0.162199 2.5806 0.32685 -6315 6 17.3589 40.4121 27.3072 22.6925 26.1242 -9.80885 -6316 4 17.3318 41.3765 27.4299 10.8839 -2.3351 -5.50809 -6317 4 16.5554 40.1462 27.6883 -41.5002 -17.3681 16.6281 -6318 6 8.67113 4.89706 8.92484 12.0335 -9.87957 -4.1983 -6319 4 8.33733 5.39218 8.1724 -5.0195 2.6367 -1.72337 -6320 4 8.22391 5.22927 9.70847 -2.49168 4.71619 2.25155 -6321 6 39.5722 17.6819 9.57834 18.7012 -23.4437 -36.958 -6322 4 39.2207 17.6668 10.4653 -7.32211 -9.11094 11.7967 -6323 4 39.6226 16.7555 9.16114 -8.90732 35.1542 21.3272 -6324 6 31.4906 30.1663 28.5669 -18.2413 -3.40307 10.1233 -6325 4 32.2933 30.4252 28.099 2.93126 -8.695 5.25695 -6326 4 31.6493 29.3506 29.0723 8.50077 6.58979 -7.17605 -6327 6 52.667 19.2904 40.0609 -3.10376 4.72625 -3.48654 -6328 4 52.9542 18.5867 39.4362 -2.88314 13.2503 8.01058 -6329 4 53.0181 20.1618 39.7754 -0.243354 -8.89628 -7.05583 -6330 6 3.24103 7.80987 9.85575 15.4795 13.9798 -0.387217 -6331 4 3.75934 8.59525 10.1836 -13.0283 -21.6848 -11.3123 -6332 4 3.84189 7.30622 9.27659 -5.58147 6.91981 6.81825 -6333 6 23.1336 35.2172 35.587 -21.8844 -14.3383 30.559 -6334 4 23.8289 35.3646 34.9695 18.2116 12.6911 -23.5817 -6335 4 22.438 35.8962 35.5045 5.76256 0.966742 -5.52301 -6336 6 19.4997 14.0668 20.8253 -20.4482 -5.33672 -12.8711 -6337 4 19.9465 14.5101 21.5526 -0.10572 6.16799 9.82761 -6338 4 18.517 14.0876 20.9737 19.1914 1.01522 3.6393 -6339 6 23.6166 15.8675 24.0247 18.6101 -11.8924 -11.0295 -6340 4 23.7056 16.8159 24.0204 -5.88143 19.7526 4.0278 -6341 4 24.4592 15.5679 23.6279 -14.5441 0.474754 5.50536 -6342 6 0.271665 30.4941 6.10208 19.3679 10.4089 38.3983 -6343 4 55.0639 30.1609 5.24948 -13.9023 -9.5098 -30.2095 -6344 4 54.47 30.83 6.54681 -8.02886 -2.57547 -7.81581 -6345 6 4.88814 13.205 29.1223 -11.8587 -43.2127 -22.2411 -6346 4 4.78002 13.8458 29.7909 -3.08187 32.2273 31.1649 -6347 4 5.63816 13.4614 28.593 12.4558 6.3486 -8.85318 -6348 6 54.2078 27.2696 19.1963 -15.9712 -23.151 25.2067 -6349 4 0.0774591 27.3551 19.591 11.6552 0.895327 2.86932 -6350 4 54.2345 27.7605 18.3958 2.66703 17.7524 -27.3595 -6351 6 13.918 35.7451 9.18145 -1.78919 -38.7722 -17.1362 -6352 4 13.6805 34.9997 8.54227 8.11159 28.2534 18.027 -6353 4 13.9675 36.5302 8.63631 -0.993585 8.08981 -9.4946 -6354 6 5.91273 31.9181 18.8024 -12.4461 1.37758 17.74 -6355 4 5.51416 32.8097 18.9023 4.86685 -6.68339 -12.1033 -6356 4 6.30341 31.7597 17.9414 -1.0189 10.0948 -10.5031 -6357 6 5.79665 28.8753 9.48388 1.22923 1.68801 -9.18455 -6358 4 5.13151 29.3325 10.0083 -4.81051 1.68465 1.48607 -6359 4 5.29369 28.2634 8.9143 2.26517 5.17431 2.85494 -6360 6 40.1173 6.05944 9.72118 13.8961 -11.6659 -14.1698 -6361 4 40.0092 6.65032 8.94634 5.33155 -13.6 11.5113 -6362 4 40.8322 5.39707 9.49335 -23.1878 23.6737 0.508505 -6363 6 20.33 13.449 41.3936 11.1096 -0.534149 -19.18 -6364 4 21.2311 13.7006 41.7531 -26.0398 -5.61362 -19.048 -6365 4 20.2547 13.6822 40.4168 8.50391 -3.95591 26.8537 -6366 6 14.4455 21.736 27.3642 10.1345 -2.11962 18.0607 -6367 4 15.3888 21.7922 27.5976 -10.3958 0.0660495 -7.924 -6368 4 14.3649 21.6255 26.4124 4.42937 0.724974 -0.20238 -6369 6 38.7561 1.79551 30.0553 7.9914 -17.3849 -15.575 -6370 4 38.4573 2.01955 30.9195 -8.42419 6.13431 27.6354 -6371 4 38.9299 2.64677 29.6557 3.10695 8.29419 -8.65227 -6372 6 5.60526 10.8558 14.1801 -12.7318 -17.5226 5.68918 -6373 4 4.9397 11.5438 14.0518 -0.153792 0.369728 -2.18729 -6374 4 5.10481 10.0791 14.5379 11.5553 16.0131 -9.09073 -6375 6 45.3957 36.7129 27.9145 12.4213 23.5208 -28.0365 -6376 4 46.0624 36.7782 28.6036 -4.12954 -6.22049 8.27184 -6377 4 45.8092 37.2197 27.1638 -19.7894 -19.9635 17.4029 -6378 6 54.0798 35.0308 20.3994 -2.843 -1.86615 -11.5734 -6379 4 53.8804 34.0877 20.4832 1.52986 -2.36109 -0.337181 -6380 4 53.937 35.2424 19.4598 0.882668 -0.831705 10.9264 -6381 6 42.0694 14.2202 28.4717 21.1483 -3.98018 21.7174 -6382 4 41.9885 13.9669 29.4143 -10.3093 2.59547 -11.4583 -6383 4 43.02 14.3987 28.405 -3.82604 1.35242 -7.96462 -6384 6 34.8498 7.69636 26.7062 10.2576 -3.81921 3.94078 -6385 4 35.6291 7.30563 27.124 0.895866 5.46509 7.50645 -6386 4 34.5698 7.0105 26.0965 -7.64543 -1.95318 -6.87837 -6387 6 49.6738 30.7035 23.8555 -19.3272 -4.41511 -13.3992 -6388 4 50.4901 31.166 23.8286 28.3544 13.2291 -0.764283 -6389 4 49.8241 29.9642 24.4268 4.30872 -17.0733 16.2757 -6390 6 50.9008 7.796 14.1645 9.55664 -5.64416 8.78132 -6391 4 50.8079 7.01141 13.6383 2.57079 -23.1487 -4.84087 -6392 4 50.5017 8.45024 13.6177 -13.1237 27.0593 -11.2067 -6393 6 4.26801 39.4668 27.8349 5.05862 -9.29033 0.915363 -6394 4 3.69733 40.2352 27.9464 -2.13812 3.43039 0.251988 -6395 4 3.85787 38.9439 27.1453 -8.48589 -4.99062 -8.23097 -6396 6 8.74801 32.8245 8.20645 -16.3778 -23.5545 -4.64115 -6397 4 8.1587 32.1369 7.77132 15.1044 25.0089 5.08958 -6398 4 8.83862 33.6223 7.65804 -4.44885 -3.27239 -3.39484 -6399 6 52.9644 25.4956 9.38778 -23.0628 41.5097 8.07386 -6400 4 51.9653 25.4466 9.50894 36.2156 4.27363 -7.84863 -6401 4 53.1697 26.4737 9.50477 -8.20239 -39.1491 -3.41364 -6402 6 29.5595 36.7246 19.4744 18.9803 -2.04176 16.4704 -6403 4 29.6949 37.303 18.726 -4.20274 3.37351 -9.90607 -6404 4 30.4598 36.6303 19.854 -15.3589 -5.02994 0.251134 -6405 6 52.32 36.0811 25.1124 8.57954 -21.5781 -32.5589 -6406 4 53.081 35.9362 25.6725 3.50304 3.9365 6.54391 -6407 4 51.6308 36.4579 25.6293 -16.5409 10.2166 18.3955 -6408 6 21.1806 15.7021 31.1799 -1.73968 4.64344 -14.8668 -6409 4 20.7524 16.2958 30.5301 6.89899 -9.15256 14.6363 -6410 4 20.4997 15.2544 31.7027 -1.32541 3.0922 -5.22806 -6411 6 10.6615 22.4234 39.4446 2.77058 -10.3375 -21.7461 -6412 4 10.8237 22.5242 38.4595 -6.54577 -4.89624 27.0726 -6413 4 10.2823 21.5329 39.6036 8.10661 10.4602 -7.72978 -6414 6 25.1119 11.6683 22.7275 17.9584 10.1803 -43.002 -6415 4 25.2932 11.5881 23.6503 -10.3644 -4.73542 30.1579 -6416 4 24.2275 11.4525 22.4127 -3.04384 -6.16919 15.0614 -6417 6 31.7847 10.4664 2.90738 14.6232 4.92747 -25.5509 -6418 4 32.6367 10.8084 3.16838 3.35352 3.27745 17.8769 -6419 4 31.9203 10.4929 1.94425 -15.217 -5.45404 8.94289 -6420 6 52.4827 36.4345 22.1596 -7.80713 -36.8893 3.58418 -6421 4 53.0619 36.0081 21.4904 -7.85296 7.00584 7.09748 -6422 4 52.1113 35.6558 22.6625 11.8438 27.843 -13.8236 -6423 6 46.2218 40.0356 27.0002 3.00948 19.3103 18.0239 -6424 4 46.4695 39.2891 26.4839 7.60887 -23.2108 -12.3358 -6425 4 45.8298 40.6551 26.3816 -4.98516 2.75312 2.41297 -6426 6 24.0859 36.731 39.1057 28.0861 3.14637 -13.7231 -6427 4 23.7868 35.8298 38.9338 -5.18553 -0.74556 5.28182 -6428 4 23.4629 37.185 39.6652 -17.6872 -1.49015 10.8999 -6429 6 22.3474 7.42423 31.8108 -22.1464 -34.764 6.81692 -6430 4 22.3426 8.34479 32.0749 -0.491553 12.3501 5.32307 -6431 4 21.6443 6.94951 32.3421 24.5486 22.6275 -17.4273 -6432 6 14.3601 18.3609 4.10227 -5.91068 -17.6869 34.0105 -6433 4 14.0198 17.4467 4.00899 4.58845 16.3972 -3.13031 -6434 4 14.1964 18.4938 5.07185 10.0688 2.42213 -23.7444 -6435 6 27.3176 38.4584 0.118061 26.6324 1.72941 22.4386 -6436 4 26.8721 39.2229 0.514978 -6.24738 0.955789 -1.68833 -6437 4 28.1825 38.4197 0.615747 -27.5588 -2.17115 -12.0629 -6438 6 18.6641 0.153005 12.2455 -30.1585 11.9093 7.70812 -6439 4 17.6838 0.288413 12.4195 29.795 -10.6896 -3.23208 -6440 4 18.9224 41.3021 12.7767 -6.14336 -8.14908 8.56265 -6441 6 49.4289 24.9791 25.34 -2.93287 6.40986 -7.21031 -6442 4 48.5336 24.6845 25.5066 -4.79022 -10.2209 3.00881 -6443 4 49.2657 25.7332 24.7569 10.0796 0.538989 -0.302405 -6444 6 52.0657 20.2866 15.752 -30.988 -5.77477 12.2451 -6445 4 52.9883 20.4648 15.7877 30.7647 6.19501 2.10932 -6446 4 51.7487 20.318 16.6754 2.59628 0.707672 -8.61894 -6447 6 49.6694 15.6466 38.5033 -2.36871 5.8496 0.21755 -6448 4 49.1634 15.9354 37.7317 2.81773 -6.75889 -8.88584 -6449 4 49.3364 16.2327 39.1899 -1.1635 1.82265 11.9188 -6450 6 15.9209 23.7098 13.4125 14.0576 3.0382 28.6395 -6451 4 16.4576 23.7581 14.2247 -6.14337 -14.5589 -15.9509 -6452 4 15.4928 24.5639 13.4473 -12.8057 7.70559 -12.0572 -6453 6 14.3535 29.1644 14.3158 -5.44214 8.41065 -10.6214 -6454 4 14.1107 29.5404 13.4323 4.3831 -8.60004 22.5031 -6455 4 14.1668 29.874 14.9595 1.02369 -3.68708 -8.8215 -6456 6 30.4209 19.8501 16.8941 13.513 -29.8099 -4.40702 -6457 4 30.8419 19.6061 17.7309 -1.16118 4.00396 0.0836579 -6458 4 29.8867 20.6126 17.0073 -13.0379 22.0094 6.56408 -6459 6 21.3171 21.0315 23.1347 13.77 4.04154 19.3244 -6460 4 22.2214 21.2364 23.4619 -15.8088 -1.32345 -6.31481 -6461 4 20.7299 21.1568 23.8987 5.07857 1.54253 -3.54042 -6462 6 32.3393 0.431439 25.2563 20.1104 -9.0179 2.05206 -6463 4 32.3376 0.357033 24.2893 -5.83171 4.85221 4.50445 -6464 4 31.4939 0.740536 25.5658 -20.5297 5.12544 -3.04931 -6465 6 26.1412 32.4208 27.5133 11.9844 8.82666 12.5058 -6466 4 25.6297 33.2181 27.3271 -3.7928 0.326337 -6.17907 -6467 4 25.9506 31.7475 26.8638 -6.12498 -3.36782 -14.5181 -6468 6 31.6886 23.0183 41.4596 0.904697 7.64904 11.3452 -6469 4 32.5758 22.6752 41.6838 -11.075 0.532718 -2.08438 -6470 4 31.0649 22.7115 0.227606 5.71652 1.16966 -4.3825 -6471 6 54.3662 17.838 10.7289 1.16641 13.6113 28.4031 -6472 4 53.5784 18.2682 10.4091 -15.835 11.3767 1.3744 -6473 4 54.5574 17.2244 10.05 12.0924 -25.2322 -22.7117 -6474 6 15.4007 28.5656 8.62044 -26.1749 5.76845 -41.3303 -6475 4 14.7273 28.9702 8.01425 13.7656 -2.21873 23.1298 -6476 4 15.8479 27.9621 8.001 5.22436 1.48231 12.0756 -6477 6 21.9302 22.318 27.6758 1.68517 -22.7815 -10.3197 -6478 4 22.2029 23.2377 27.6948 5.32233 7.77922 8.4028 -6479 4 21.9507 21.9579 28.5708 1.77406 4.33165 6.10734 -6480 6 2.9439 17.0434 8.14058 1.94164 -24.3442 -12.3304 -6481 4 3.71771 17.0381 7.53295 -10.9103 8.58946 10.7103 -6482 4 2.9095 17.8301 8.67828 12.1388 15.179 1.9509 -6483 6 27.5776 18.2769 3.9771 26.0492 -34.2565 5.18616 -6484 4 26.8914 18.9079 3.85686 -19.1066 25.6869 -8.0303 -6485 4 28.3968 18.6065 3.57961 -12.2542 3.89161 2.52414 -6486 6 24.7648 24.5394 8.45172 0.675902 5.99664 -6.73781 -6487 4 25.0691 23.6382 8.29185 0.995795 -2.08458 0.0885467 -6488 4 24.6379 24.6158 9.40394 1.7631 1.80546 -0.516948 -6489 6 41.9985 30.4652 13.7873 -12.418 22.2399 8.0521 -6490 4 42.948 30.5766 13.6065 -4.54142 -18.1038 -0.632901 -6491 4 41.6543 29.5567 13.7855 17.2179 -0.450275 -1.52495 -6492 6 15.7003 34.688 41.5836 22.5583 -4.71252 2.77114 -6493 4 16.4414 35.3131 41.7067 -7.89455 1.74939 1.29748 -6494 4 14.9091 35.1782 41.7999 -10.5684 8.94915 5.66738 -6495 6 11.14 19.7709 40.5827 8.16812 -24.8495 -13.7269 -6496 4 12.099 19.6958 40.4335 -6.97557 5.6239 6.72769 -6497 4 10.8269 18.8658 40.3418 -4.09458 16.1616 8.77151 -6498 6 47.4994 34.5266 14.3059 -7.29954 -13.2064 -47.3862 -6499 4 46.9486 35.2618 14.0194 -1.26876 14.2822 14.9014 -6500 4 47.5134 34.0178 13.447 14.161 -1.19014 30.6955 -6501 6 12.4113 26.9599 28.4986 7.53387 -39.615 -11.3807 -6502 4 13.2389 26.8759 29.0383 -9.69033 -7.26437 -10.917 -6503 4 12.3547 26.143 27.8911 8.77392 33.3418 27.7102 -6504 6 27.6324 16.2078 39.8226 -15.7166 38.3334 10.2244 -6505 4 27.1738 15.4871 40.2515 -0.529449 -16.0233 0.418904 -6506 4 28.2783 15.8881 39.2072 13.4358 -18.0852 -11.4488 -6507 6 33.41 31.2223 27.2648 1.06056 32.1352 -34.8736 -6508 4 34.1408 31.8147 27.4795 4.37007 -7.45055 8.12396 -6509 4 32.9956 31.7298 26.5244 2.74339 -19.701 12.9858 -6510 6 39.1079 39.5697 31.9277 -2.55925 2.09297 0.92959 -6511 4 38.7672 39.6549 31.0188 2.43701 -1.71218 7.87361 -6512 4 38.6143 40.212 32.4659 5.60044 -5.69156 -1.85126 -6513 6 22.8777 16.5449 19.9566 -5.65986 -8.80894 -1.36967 -6514 4 23.3352 15.8067 20.4264 -14.7096 4.17994 -10.0586 -6515 4 22.0919 16.2116 19.4632 15.4216 -6.99735 9.66589 -6516 6 23.9693 21.8661 10.5894 -36.2244 3.36606 3.40233 -6517 4 22.9782 21.9097 10.6297 20.8239 3.29656 -5.85881 -6518 4 24.1356 21.2379 11.286 10.3432 -8.66819 12.8402 -6519 6 40.1777 25.441 2.79106 -10.2872 18.2283 6.37262 -6520 4 40.1705 25.0132 3.63888 8.49445 -17.5146 10.0011 -6521 4 39.7592 26.2809 3.01477 -1.02299 2.45309 -8.63041 -6522 6 15.0237 19.7749 9.41859 -29.0071 17.4399 5.80075 -6523 4 14.7228 20.7104 9.1599 7.38 -34.1593 9.70733 -6524 4 14.2459 19.2857 9.84339 25.5779 21.3804 -17.4983 -6525 6 7.16152 24.8628 0.123297 -7.02966 -3.56682 11.7049 -6526 4 7.96668 24.8036 41.5398 15.214 -7.46464 -23.6733 -6527 4 7.46323 25.2953 0.914133 -6.27594 4.44234 13.0485 -6528 6 43.3927 10.9201 31.3407 25.4071 10.106 7.84859 -6529 4 43.8098 10.8609 30.45 -7.40798 -0.791197 19.4909 -6530 4 44.1598 10.9733 31.9767 -21.009 -0.343387 -21.8186 -6531 6 13.8353 19.068 27.8558 -6.19586 12.3763 0.85665 -6532 4 12.975 18.7858 28.1864 -1.64107 2.23065 2.52451 -6533 4 13.8413 20.053 27.8412 2.88957 -13.8419 -2.19198 -6534 6 3.4728 19.5924 9.6022 -44.5705 9.69836 1.75794 -6535 4 2.70361 20.0095 10.0844 20.5969 -13.9146 -9.89239 -6536 4 4.25765 19.8234 10.0844 13.5534 0.0599395 5.99295 -6537 6 51.0213 19.4268 7.70955 2.43945 12.0622 -23.2725 -6538 4 50.6325 20.2627 7.28999 21.6228 -31.5555 10.1722 -6539 4 51.8004 19.115 7.16203 -27.7652 18.9123 7.69536 -6540 6 42.2139 2.59999 10.4154 11.3377 -7.01405 -0.847173 -6541 4 43.144 2.57533 10.7556 -19.516 1.89174 -10.2127 -6542 4 42.1979 2.39197 9.45142 9.27815 6.14572 20.7298 -6543 6 30.7794 6.42968 35.1975 -13.4378 -7.3385 -2.08895 -6544 4 29.8146 6.43175 35.3648 9.73054 -4.02703 -1.93701 -6545 4 31.052 5.50707 35.0427 -6.67101 6.52405 0.860042 -6546 6 52.8733 36.9495 18.5906 -4.95733 10.1612 -6.16245 -6547 4 51.9909 36.5548 18.5738 -2.549 -5.51132 1.40056 -6548 4 52.7192 37.8514 18.247 7.64894 -10.0112 4.74408 -6549 6 44.2058 6.2999 1.04709 5.21291 8.10008 11.2107 -6550 4 44.5368 6.97198 1.69742 -2.24215 -10.2401 -12.34 -6551 4 44.9393 6.09517 0.464894 1.54959 1.89788 1.1267 -6552 6 42.1369 38.61 31.1886 17.67 -9.24899 26.4806 -6553 4 41.7623 38.8803 30.3687 -14.3725 6.55505 -24.001 -6554 4 41.498 38.8614 31.8609 -3.32676 4.75778 -0.202389 -6555 6 43.7164 12.7972 9.05712 5.81528 3.72875 -30.711 -6556 4 43.3247 13.6946 8.89573 9.87346 -21.9812 3.16194 -6557 4 44.14 12.4709 8.19462 -12.6006 16.8915 32.7492 -6558 6 13.3844 0.443398 6.51083 -17.4423 24 5.83044 -6559 4 13.1471 1.18968 7.12521 11.9969 -17.0568 -16.1514 -6560 4 13.404 0.824606 5.60344 -0.330864 -2.32474 10.3957 -6561 6 16.1322 13.2809 10.2756 -7.67495 0.483234 -7.74316 -6562 4 16.9315 12.7781 10.4995 -2.28882 -8.98658 -2.43525 -6563 4 15.4389 12.669 9.92885 16.2568 3.72445 6.60733 -6564 6 1.59909 8.47465 4.69565 -12.106 -24.0688 17.9122 -6565 4 1.97809 9.06493 4.05503 13.7499 12.9224 -12.6029 -6566 4 2.17818 8.51684 5.47441 1.43398 4.73372 -5.14276 -6567 6 37.2847 1.71984 10.5234 11.0189 -27.5723 -13.4042 -6568 4 37.2468 2.67416 10.4778 -4.00861 9.27523 10.0347 -6569 4 36.8996 1.35439 11.335 -2.27729 16.2243 3.90618 -6570 6 53.8329 9.87891 17.6846 -38.3798 -30.924 7.14602 -6571 4 54.5301 10.0186 17.0634 18.0368 1.02749 -18.7159 -6572 4 53.3473 9.06138 17.3773 12.8854 20.2391 7.24153 -6573 6 45.4804 30.6107 15.8042 -8.04753 0.598448 7.23065 -6574 4 44.8245 31.2304 16.205 12.7241 -16.0174 -7.51778 -6575 4 45.2045 29.6903 15.9459 -0.384376 11.4708 0.631615 -6576 6 39.9212 16.643 33.8508 -27.7636 -7.17353 -19.4615 -6577 4 39.1766 17.1755 33.458 21.1378 -12.4278 10.7513 -6578 4 39.8244 15.7487 33.4296 5.23768 21.8708 14.061 -6579 6 32.8655 24.7639 27.9361 20.284 59.6053 -7.49862 -6580 4 33.6165 25.1458 28.4374 -8.60268 -19.6727 -0.650124 -6581 4 32.6313 25.5876 27.4183 -1.69816 -34.155 10.7383 -6582 6 7.87466 31.6143 24.1101 1.9117 20.6925 26.3443 -6583 4 7.66972 30.8573 24.7192 5.27436 26.873 -8.7819 -6584 4 7.9908 32.4716 24.6533 -12.57 -44.6195 -20.0842 -6585 6 43.5378 41.3358 15.8218 9.28004 -2.58796 -1.50951 -6586 4 43.1443 0.2957 15.6997 -2.19094 2.48586 -2.7957 -6587 4 44.4004 41.3722 15.3768 -7.99823 -0.449815 2.36698 -6588 6 20.0371 29.5453 33.205 3.08504 -20.5033 -11.6211 -6589 4 20.9096 29.2965 33.5637 -2.90058 10.2459 9.35691 -6590 4 19.6251 30.2513 33.706 8.84517 7.80605 8.87396 -6591 6 43.4117 21.4438 18.6347 -11.1342 -15.0059 14.8538 -6592 4 43.0276 21.2687 19.5098 8.56326 4.46648 -0.801958 -6593 4 42.8532 20.9111 18.0542 1.01153 2.95656 -9.2223 -6594 6 3.44653 19.1197 18.4217 23.6769 1.99723 9.81042 -6595 4 3.20802 20.045 18.3207 -2.32682 2.96104 -2.33529 -6596 4 2.63398 18.6303 18.3598 -12.7596 -8.76931 -2.32568 -6597 6 41.6678 38.1102 16.3244 12.531 -42.2252 -39.0953 -6598 4 41.9368 37.3879 15.641 -15.3799 38.9729 30.6603 -6599 4 42.3331 38.0554 17.0146 -0.0757724 1.18921 2.99625 -6600 6 7.55561 36.3978 10.4983 -3.44092 15.1931 -1.45671 -6601 4 6.72339 36.2337 10.0108 12.3142 -8.52859 4.51616 -6602 4 7.946 35.5335 10.7116 -10.6452 2.04557 -4.50299 -6603 6 36.2515 19.1074 34.8142 -43.7142 -17.0801 -27.3746 -6604 4 35.3817 19.3303 34.3863 23.1726 -6.06315 12.306 -6605 4 36.4633 19.8781 35.3097 10.3 22.3537 14.1292 -6606 6 53.5678 24.9372 12.6442 30.4342 18.5181 -32.2976 -6607 4 53.8348 25.8921 12.6266 -11.9077 -21.6197 10.5864 -6608 4 54.0165 24.5977 11.8224 -16.4724 -4.37861 26.9125 -6609 6 31.6766 10.443 21.0806 4.21881 -9.06253 -2.47208 -6610 4 31.4001 9.76622 21.7243 -7.70504 9.2495 -8.08332 -6611 4 30.9288 10.6617 20.4921 1.78432 -8.02731 8.28605 -6612 6 18.1094 28.7798 17.1891 14.7524 22.0605 -19.6834 -6613 4 19.0758 28.769 16.9872 -20.2742 -2.10771 9.28657 -6614 4 17.7731 29.5847 16.7123 5.43167 -23.0331 15.3038 -6615 6 21.675 18.2354 36.8765 16.12 -15.5286 8.52342 -6616 4 22.5529 17.9072 36.565 -22.4082 10.693 4.11156 -6617 4 21.5572 17.762 37.7329 -6.04816 8.67317 -10.9669 -6618 6 25.0658 19.0188 34.2159 -51.8076 2.97265 19.7815 -6619 4 24.747 18.4039 34.9114 5.38902 10.2451 -10.362 -6620 4 25.8774 18.6629 33.96 52.7001 -22.9877 -15.275 -6621 6 15.5692 13.0234 5.56242 -6.58245 2.44228 -13.4315 -6622 4 15.9945 13.4237 6.33643 -0.981395 -11.5063 2.18089 -6623 4 15.4281 12.0558 5.58603 5.20341 13.6823 8.40676 -6624 6 54.4716 41.6235 14.8012 14.2089 2.8312 2.80672 -6625 4 54.7869 41.5367 15.7234 -10.706 -4.16636 -8.71187 -6626 4 53.6678 41.1066 14.6963 -6.31993 -3.99892 7.53898 -6627 6 1.6781 26.4654 31.3743 5.67012 -21.4195 51.4057 -6628 4 2.55869 26.331 31.7713 -6.41431 -1.4007 -7.54986 -6629 4 1.81482 26.7235 30.4972 11.6805 15.9936 -52.9786 -6630 6 32.3382 37.285 29.6856 -26.7217 17.5069 7.43983 -6631 4 31.5807 37.8924 29.918 20.5429 -15.6126 -5.39856 -6632 4 33.128 37.6701 30.0913 2.74033 -1.11204 0.131524 -6633 6 52.7155 21.0369 22.8986 -26.6856 13.1044 -7.83906 -6634 4 51.927 21.5218 22.5308 17.9584 -10.8856 16.9396 -6635 4 53.1096 20.6236 22.131 10.0871 -9.76004 -3.40095 -6636 6 32.7546 28.5936 40.5151 -16.005 5.57574 20.6704 -6637 4 31.9696 29.0914 40.2712 1.08408 5.35728 -15.103 -6638 4 32.4826 28.2925 41.3957 13.2257 -7.23298 -6.66392 -6639 6 23.6064 32.0719 16.3529 6.2601 0.887785 0.577407 -6640 4 24.375 31.9361 16.9584 -22.6405 4.1158 -3.2487 -6641 4 22.7879 32.3052 16.8361 12.3926 -5.56708 -0.502672 -6642 6 37.5201 9.16809 29.9792 -2.73778 -7.47015 7.66604 -6643 4 36.7801 8.78215 30.4957 3.311 11.363 -11.2805 -6644 4 37.2059 9.98527 29.541 -5.1069 -9.85197 8.55889 -6645 6 2.27705 24.391 14.5477 -18.8311 -23.8216 -15.5117 -6646 4 1.75426 24.0938 15.3142 10.0576 11.8704 2.19803 -6647 4 1.95568 23.7778 13.8474 11.5886 17.7779 11.9828 -6648 6 27.3753 28.7961 24.7726 7.21008 -25.2057 -20.8265 -6649 4 27.1644 28.4274 25.6317 -2.92196 -0.0765173 10.3399 -6650 4 27.4291 28.0161 24.1505 1.02404 24.316 14.9 -6651 6 16.7879 2.56531 14.3086 11.9129 14.2285 -1.69346 -6652 4 17.7185 2.38196 14.3175 13.0278 5.32386 8.84309 -6653 4 16.4775 1.81817 13.8231 -22.7045 -15.6449 -12.1127 -6654 6 21.8022 39.8027 36.8001 40.4582 11.674 1.33338 -6655 4 22.755 39.5599 36.9347 -17 12.4394 -0.288792 -6656 4 21.461 38.9709 36.5396 -21.7153 -28.8447 -11.0269 -6657 6 14.0716 6.47232 41.542 21.0202 -14.2424 -6.97231 -6658 4 14.9696 6.10406 41.5939 -1.81915 -4.72532 -7.76656 -6659 4 14.0403 6.99701 0.421866 -13.8031 9.98176 13.4178 -6660 6 14.5555 16.5106 9.31543 20.3876 4.44524 4.12907 -6661 4 15.4025 16.5964 9.78828 0.864554 -6.42184 -12.9633 -6662 4 13.9847 17.046 9.86181 -12.8914 3.93145 3.80898 -6663 6 8.66171 23.4817 30.5575 -0.244333 -0.896371 32.8135 -6664 4 9.54353 23.6001 30.2398 18.7576 4.73722 -27.2602 -6665 4 8.85707 23.3999 31.5064 -16.6456 -3.41855 -0.290363 -6666 6 37.6497 2.07069 20.0046 29.2824 -26.1096 14.9164 -6667 4 37.0584 2.2163 19.2662 -13.6051 13.4744 -1.64318 -6668 4 37.4656 2.68422 20.7276 -9.488 6.31449 -9.7769 -6669 6 42.7264 7.54802 8.0174 22.2735 -23.3375 63.966 -6670 4 43.1898 7.96838 7.30926 14.9789 10.8108 -11.9713 -6671 4 43.3711 7.43923 8.8454 -34.4126 10.1207 -51.4479 -6672 6 38.5672 29.6578 6.85692 25.3422 5.29964 1.58487 -6673 4 38.5311 29.2984 7.75245 -9.71234 0.328663 -2.10015 -6674 4 37.7248 29.5682 6.41889 -15.2832 -4.18317 0.54199 -6675 6 42.5348 15.7114 39.7967 1.15785 13.3588 -25.5786 -6676 4 42.7129 16.6429 39.5831 1.88136 -1.51067 11.9166 -6677 4 42.2359 15.3735 38.9271 3.70013 -4.77916 17.2749 -6678 6 19.8546 7.43685 22.0566 -22.5975 2.81071 25.7956 -6679 4 19.2803 8.13273 21.6746 8.521 -7.13733 1.21439 -6680 4 19.4015 7.21173 22.9242 12.7412 8.86068 -31.9054 -6681 6 27.421 3.23371 12.5304 27.0524 21.0752 -24.489 -6682 4 28.3367 3.35644 12.1327 -27.9555 -7.8832 14.1518 -6683 4 27.3543 2.31638 12.8154 4.42645 -1.52034 -0.990676 -6684 6 34.4011 6.50186 34.3664 -16.3424 -2.90191 9.94761 -6685 4 33.6712 7.15225 34.4215 6.78416 -7.62851 1.00734 -6686 4 34.1394 5.7575 34.9538 2.66911 12.7001 -5.69623 -6687 6 9.88701 27.9536 39.7574 38.1218 -1.21446 9.36845 -6688 4 10.8313 27.9815 40.1009 -35.4969 -5.93471 -11.3457 -6689 4 9.7403 28.8357 39.397 -3.9481 4.17466 -3.11552 -6690 6 50.5681 22.1235 6.40489 -3.33101 1.51672 6.50125 -6691 4 51.5163 22.3536 6.46403 -14.0562 3.33212 10.0382 -6692 4 50.0608 22.5915 7.10741 15.6039 -2.37345 -9.267 -6693 6 47.1098 11.477 30.0359 32.4056 2.61276 18.961 -6694 4 47.3696 10.9259 30.8115 -10.3246 7.95021 -16.9085 -6695 4 46.3045 11.1726 29.6407 -20.48 -14.5539 -1.24473 -6696 6 25.9367 28.4654 9.80931 -8.38409 -27.2904 31.5361 -6697 4 26.8395 28.2564 10.1264 -14.1867 1.81997 -4.27567 -6698 4 25.3175 27.9176 10.3882 19.4096 21.4407 -17.1039 -6699 6 35.4417 36.6052 19.4431 3.65383 9.51374 12.5698 -6700 4 35.4442 36.5892 20.4356 4.35023 4.13201 -20.4161 -6701 4 36.0823 37.2978 19.1702 -7.18083 -5.57131 7.61291 -6702 6 39.0947 17.861 12.3005 -1.37104 18.7141 6.38745 -6703 4 39.0516 18.8013 12.5757 6.4741 -5.57949 -8.41576 -6704 4 38.3925 17.481 12.8252 -9.64523 -10.3587 5.73293 -6705 6 2.67895 27.1328 2.39169 -0.469231 -1.96621 -7.87892 -6706 4 2.01695 27.5866 1.84113 6.06579 -3.44887 4.00529 -6707 4 2.54603 27.3828 3.31988 1.36543 -1.57126 -4.01383 -6708 6 12.3125 32.2183 21.5204 7.73608 31.3279 -34.5621 -6709 4 12.8754 32.1648 22.302 -15.5368 -9.13091 6.69049 -6710 4 11.4514 31.7997 21.5885 -0.151568 -8.94455 23.3893 -6711 6 32.8824 32.3641 8.46179 -18.8611 4.30442 3.1153 -6712 4 33.4241 32.9657 8.96292 17.2175 7.79223 5.74753 -6713 4 32.0088 32.7748 8.50666 0.635289 -6.40729 -7.5616 -6714 6 12.649 6.44414 31.9754 -2.83404 4.50046 10.0363 -6715 4 13.204 6.32185 31.2101 8.19857 -2.9014 -11.0209 -6716 4 11.7563 6.235 31.704 -2.09981 -3.08597 -3.85403 -6717 6 41.3663 27.7408 14.044 -7.1512 -14.0341 -18.9391 -6718 4 41.8178 27.3798 13.2339 -12.2472 13.3456 19.5442 -6719 4 40.4043 27.5413 13.9741 19.5004 0.843126 1.31278 -6720 6 6.61204 16.505 25.4358 4.38086 10.1107 -4.22872 -6721 4 7.40634 15.95 25.3995 -3.52048 -0.326181 -5.74655 -6722 4 5.93615 16.0015 24.9584 5.4209 -2.01242 3.85811 -6723 6 21.7595 39.2992 13.3504 -47.5104 6.20728 42.9111 -6724 4 22.3466 39.2605 12.6295 26.4998 6.28224 -34.1528 -6725 4 21.7095 40.2078 13.7281 10.6984 -16.5323 -14.9329 -6726 6 34.8487 6.01484 6.95222 -29.6963 0.326386 -14.1862 -6727 4 33.862 5.88861 6.88689 25.1099 2.0969 11.0318 -6728 4 35.0754 6.24807 6.0365 6.49139 -1.48305 5.74594 -6729 6 33.0274 30.4243 33.1708 -20.2868 -13.6057 -33.0226 -6730 4 32.107 30.5622 32.8069 24.6222 -1.48625 15.7647 -6731 4 33.1252 31.0225 33.8918 -2.19017 18.1524 16.6028 -6732 6 15.459 32.4153 12.1907 25.026 -14.7999 12.6103 -6733 4 16.3707 32.0454 12.2858 -22.5133 7.43237 -2.39957 -6734 4 15.4871 32.8857 11.3664 4.63911 10.1509 -16.175 -6735 6 12.6896 26.6018 21.3639 -15.0944 -25.6853 -2.70918 -6736 4 11.948 26.0906 21.6799 0.937138 -29.673 -19.3981 -6737 4 12.542 27.2759 21.9777 19.0907 58.813 21.5342 -6738 6 47.0229 36.3064 29.9951 -7.32095 -4.41829 24.4392 -6739 4 47.4263 37.0889 30.4354 -10.9743 -13.05 -1.23566 -6740 4 46.4286 35.8162 30.6445 23.161 23.2616 -16.2608 -6741 6 0.29284 12.714 23.4069 -35.5625 7.7859 6.41586 -6742 4 0.591011 11.8915 23 -3.04289 0.952694 -0.179009 -6743 4 54.2726 12.6526 23.4069 36.7156 0.482893 -0.227565 -6744 6 54.1717 18.9252 21.5683 -50.0663 20.0699 0.290361 -6745 4 -0.00468748 18.6783 21.9698 30.2345 -16.5238 -1.58257 -6746 4 54.0846 18.73 20.626 15.626 -5.42297 0.74208 -6747 6 25.7258 24.2992 23.7444 19.803 -45.4072 -0.235584 -6748 4 25.1532 23.5493 23.4006 14.0979 28.9064 13.4272 -6749 4 26.557 23.8171 24.0636 -29.432 23.3848 -10.2309 -6750 6 11.8983 29.0288 26.8736 6.09277 -0.515715 3.71925 -6751 4 12.595 29.6797 27.0784 -3.35093 -5.68029 1.25498 -6752 4 11.9864 28.3255 27.5444 1.01315 10.8055 -7.75858 -6753 6 47.9911 35.8567 10.6981 8.08413 -4.02984 -21.6227 -6754 4 48.7745 35.7734 10.1229 -13.6418 -1.85084 -2.1863 -6755 4 48.3792 36.2903 11.4463 -1.30569 7.34959 21.4512 -6756 6 47.672 29.8438 36.9511 38.562 -32.0587 -16.7646 -6757 4 48.1514 29.311 36.2244 -26.8687 25.3781 26.6073 -6758 4 46.9232 30.3209 36.5927 -0.690739 -0.634879 -8.58348 -6759 6 7.33835 12.3416 10.615 -8.89583 -3.33234 -10.1121 -6760 4 7.22469 12.7824 9.73793 -1.24183 -8.23722 19.221 -6761 4 6.50851 12.5236 11.1156 17.4449 -0.896679 -14.5349 -6762 6 52.929 15.961 4.90278 -10.2898 -1.28264 -8.50781 -6763 4 53.0348 16.1145 3.95774 -1.18717 -0.815743 4.35872 -6764 4 53.806 16.0238 5.26597 15.814 -0.370642 9.21047 -6765 6 10.6777 16.9586 34.6035 -55.1347 -38.7426 5.67968 -6766 4 10.8984 16.7766 35.5088 23.7364 14.024 15.8473 -6767 4 9.8802 16.3472 34.5582 30.0556 27.9196 -18.3163 -6768 6 25.1377 31.056 36.0048 1.42921 -10.848 -28.6765 -6769 4 25.7744 31.7772 36.0714 -0.417948 1.95283 3.18329 -6770 4 25.3475 30.6244 35.1463 -8.66047 8.51414 18.9355 -6771 6 34.0941 21.8921 41.4705 -2.59948 8.49748 21.8065 -6772 4 33.8376 21.0023 41.2487 -0.891159 -17.6747 -3.00217 -6773 4 34.5263 22.2081 40.6953 10.3371 11.5397 -24.1167 -6774 6 15.7674 30.0637 1.25444 19.4532 4.17941 -23.0135 -6775 4 15.204 30.4318 1.91689 -16.4157 4.77211 21.8875 -6776 4 16.1981 30.8773 0.915598 -5.77798 -19.2538 1.08217 -6777 6 29.5177 27.8662 16.6069 -21.9867 -20.8772 26.8051 -6778 4 29.4575 26.8938 16.8925 2.72258 42.9501 -5.19299 -6779 4 28.8337 28.3532 17.1557 16.905 -14.8206 -13.8895 -6780 6 39.6418 9.77683 0.55649 6.97543 15.8838 23.3716 -6781 4 40.1108 10.6055 0.868863 -11.4024 -23.0197 -7.66085 -6782 4 39.4946 9.23542 1.36828 3.21978 8.9832 -14.2415 -6783 6 1.52158 31.8692 16.4183 -13.8984 7.04184 27.8471 -6784 4 2.05742 32.2974 15.7673 16.5414 8.9668 -16.2997 -6785 4 1.54493 30.9444 16.2035 3.31157 -20.7597 -8.56027 -6786 6 8.73651 39.8559 25.0424 -4.76165 -15.5453 0.0774869 -6787 4 8.05377 39.648 25.6948 0.177415 -5.7342 -2.33302 -6788 4 8.86744 40.7877 25.1714 9.39418 20.2019 -3.50565 -6789 6 42.3206 10.2864 9.76098 2.95973 19.1246 -1.63703 -6790 4 42.201 10.133 10.7061 4.21692 -0.996774 -0.328573 -6791 4 42.7677 11.1578 9.6855 -5.09192 -13.1904 -0.0451331 -6792 6 13.2407 7.61713 1.96996 -7.39862 -1.41628 8.88927 -6793 4 13.9913 7.91748 2.51852 -7.45732 -2.50241 0.703823 -6794 4 12.5579 7.21318 2.54911 15.3337 9.06064 -6.21655 -6795 6 18.7418 40.0591 14.2229 14.6643 6.60726 6.61579 -6796 4 19.3344 39.8885 14.9901 -13.3575 3.17545 -12.3588 -6797 4 17.9636 39.4956 14.2872 3.6042 -5.87931 7.54738 -6798 6 20.1073 14.0529 38.5598 27.8117 -61.2518 1.76132 -6799 4 20.1641 13.6472 37.6602 -4.05869 13.902 17.7453 -6800 4 19.784 14.907 38.4293 -21.3136 56.4597 -12.4562 -6801 6 22.6529 28.8869 34.0687 6.58134 -12.6264 20.4136 -6802 4 23.051 28.2341 33.486 -0.980474 2.102 -8.59088 -6803 4 22.967 28.5961 34.9503 -6.50134 7.38476 -6.63172 -6804 6 22.6736 4.71248 5.24178 -0.00794307 -2.96021 -16.86 -6805 4 22.1728 3.90748 5.48978 2.26378 16.1145 9.27739 -6806 4 22.7088 5.35566 5.95806 -4.05577 -5.29394 11.9552 -6807 6 23.6374 34.0001 38.3917 50.061 26.1352 -20.3518 -6808 4 22.8137 33.6238 38.6177 -41.7704 -11.5062 -0.965889 -6809 4 23.6153 34.3835 37.4812 -9.56218 -11.3792 16.4738 -6810 6 48.3816 21.3644 17.2759 -0.964958 21.4078 15.1884 -6811 4 48.1603 22.346 17.2347 5.31328 -30.3781 -7.15015 -6812 4 48.2799 20.9337 16.4123 -2.86285 15.3202 1.32987 -6813 6 11.5786 11.0066 8.63803 -22.8025 30.9503 41.2381 -6814 4 11.6342 10.2487 9.24135 6.24209 -4.12245 -6.65597 -6815 4 11.0653 11.6976 9.17674 20.0011 -23.9124 -25.5895 -6816 6 40.098 28.1667 33.502 25.4322 5.13826 0.328547 -6817 4 41.0532 28.3457 33.4282 -8.43417 -7.39989 8.78785 -6818 4 39.8078 28.5143 32.6608 -12.8477 1.2165 -2.93222 -6819 6 47.3852 25.6796 5.28879 12.5804 32.9376 -10.0311 -6820 4 46.4546 25.5561 5.13624 -16.8804 -10.2001 -0.268496 -6821 4 47.5232 26.6241 5.03253 2.87445 -14.5067 3.75712 -6822 6 21.6604 35.221 23.9985 9.0652 15.9564 -12.6156 -6823 4 21.5339 34.4977 24.6161 5.50034 -7.33202 6.93593 -6824 4 22.5891 35.5406 24.0132 -10.9025 -9.97729 6.37443 -6825 6 8.25067 41.5023 8.40693 4.57396 0.593767 -7.67714 -6826 4 8.14583 40.8128 7.73311 1.23406 2.32353 -0.157563 -6827 4 7.86929 41.1416 9.20784 -2.18245 3.41182 6.12515 -6828 6 16.4756 31.0916 22.2208 -15.8048 -5.76047 -3.57767 -6829 4 16.9823 30.8797 21.4186 0.224111 -1.11381 3.57708 -6830 4 17.0871 31.1495 22.9566 10.3822 -1.94934 1.40451 -6831 6 54.7052 0.441622 28.3216 30.4392 7.42547 7.16367 -6832 4 0.670225 0.280878 28.2941 -2.60978 -25.0778 -11.1355 -6833 4 54.7831 1.35385 28.5964 -22.0828 12.0381 3.63841 -6834 6 48.4365 15.3814 4.18175 16.1137 -59.8395 -8.29881 -6835 4 49.2486 15.0627 4.66696 -19.7577 20.5705 -9.22457 -6836 4 48.202 14.5739 3.61717 1.65501 39.0327 16.4105 -6837 6 34.3447 6.98096 40.4233 28.1894 -26.1309 -0.966046 -6838 4 33.5941 7.1072 39.8443 -1.28272 -2.58724 -7.46065 -6839 4 35.0352 6.39393 39.9745 -30.768 20.5054 8.50532 -6840 6 41.3452 3.36617 16.9999 -11.8967 -16.9054 2.63506 -6841 4 41.0249 2.72492 17.6694 2.1854 6.18106 -7.89089 -6842 4 41.9449 3.92974 17.49 7.08552 9.22633 4.28017 -6843 6 48.4488 20.6937 14.5344 36.1561 -40.2628 27.2518 -6844 4 47.9962 21.3635 14.0898 -25.7182 45.1623 -29.349 -6845 4 49.3977 20.8911 14.4834 -7.22111 0.680744 -3.09477 -6846 6 52.5006 28.1422 37.1181 -0.438891 10.9489 1.55023 -6847 4 53.461 28.2559 37.0441 -2.53591 -5.73983 -7.32344 -6848 4 52.1579 27.9957 36.2188 6.05301 2.29627 6.02383 -6849 6 53.8778 18.5596 18.7916 -16.4261 -54.6782 2.06415 -6850 4 54.6924 18.1462 18.492 5.89253 -2.608 -0.931268 -6851 4 54.0684 19.4623 18.7843 11.279 55.5152 0.463912 -6852 6 40.9954 39.1455 28.7887 -28.6383 -4.85259 53.4888 -6853 4 41.3933 39.2419 27.9663 30.849 7.00679 -57.5311 -6854 4 40.0484 39.2316 28.6375 -4.32997 -1.25138 -0.266272 -6855 6 38.2708 8.75593 24.2289 27.2886 -4.9888 -5.43324 -6856 4 39.2171 8.59021 23.9715 -26.3742 3.09491 7.04217 -6857 4 38.3303 9.34105 24.9905 -3.83131 2.71498 5.53525 -6858 6 2.99948 29.1469 9.63392 26.6909 -34.1608 2.5373 -6859 4 2.51216 28.7995 8.89273 -4.75194 -2.8028 -9.24178 -6860 4 2.58111 29.9575 9.82954 -15.8869 33.6035 13.3424 -6861 6 27.5773 29.2771 18.3181 4.27818 -11.5166 33.1226 -6862 4 26.7531 29.1546 17.8331 -9.3021 -0.872639 -4.78576 -6863 4 27.3558 28.9731 19.2647 9.0806 12.9475 -44.783 -6864 6 11.8527 21.1658 10.1208 3.44892 -32.1211 19.512 -6865 4 12.1978 22.0146 9.89711 8.39983 22.4635 -8.03232 -6866 4 12.4593 20.8304 10.8135 -12.0936 9.66798 -13.0295 -6867 6 16.8988 32.3014 0.299949 1.29982 1.68058 -0.586211 -6868 4 17.7043 32.7282 0.600499 13.9817 -1.747 3.00212 -6869 4 16.3216 33.0562 0.17902 -12.1561 7.80428 -5.7129 -6870 6 1.309 17.4831 22.5447 23.3848 -11.3219 -15.6007 -6871 4 1.13597 16.5744 22.1718 3.15619 19.2398 8.80125 -6872 4 2.27868 17.6899 22.4311 -25.7511 -7.40397 3.71946 -6873 6 41.5587 6.87311 29.3039 4.08196 29.5448 1.53382 -6874 4 41.6919 5.95311 29.5356 2.80206 -5.98386 3.69024 -6875 4 41.9106 7.40602 30.0483 -3.99043 -10.4039 -5.51054 -6876 6 10.5167 10.7886 13.8618 17.7458 -17.1897 13.2051 -6877 4 10.6632 11.2096 13.003 1.79898 0.261401 -4.84225 -6878 4 11.2159 10.1 14.0373 -16.1376 17.4326 -7.31573 -6879 6 39.8332 15.4952 40.8309 13.3581 4.75609 3.89566 -6880 4 39.9392 16.0809 40.0548 0.3292 -3.56753 7.15077 -6881 4 40.6564 15.5643 41.3732 -15.0531 5.58747 -11.8726 -6882 6 26.5094 19.6057 40.5003 9.17758 -2.41024 9.24949 -6883 4 27.4312 19.885 40.5187 -1.32295 2.31326 -8.74715 -6884 4 26.4504 19.08 41.3172 -10.7617 -0.025449 -2.36491 -6885 6 54.0331 8.19348 13.7645 20.1265 23.4755 -3.20859 -6886 4 54.5379 7.42769 14.0195 10.1236 -9.46733 3.3174 -6887 4 53.1635 7.89609 13.5919 -33.2862 -9.18344 -4.84573 -6888 6 15.685 25.3343 10.6639 3.77823 -5.01457 0.699023 -6889 4 15.2925 25.3549 9.7704 -6.94194 -0.507815 8.78718 -6890 4 14.9859 25.2981 11.3464 3.26271 -0.250944 -15.837 -6891 6 18.6044 3.42728 21.9359 54.0117 -4.17358 13.1129 -6892 4 19.6007 3.50499 22.1915 -55.8621 -1.2706 -18.0159 -6893 4 18.5414 3.70523 21.0018 -0.6471 0.781857 10.4283 -6894 6 50.8906 20.6382 18.514 19.322 19.8933 14.7131 -6895 4 50.0771 21.0514 18.1693 2.40506 3.30677 2.13188 -6896 4 51.4314 21.2881 19.0676 -26.3068 -18.4046 -20.3942 -6897 6 53.3692 20.9044 31.2861 -2.87581 -0.0590227 -4.61483 -6898 4 53.3163 20.8663 32.2507 -1.10677 -1.05899 -2.14121 -6899 4 52.4655 20.8115 30.924 8.48272 0.484508 7.85381 -6900 6 52.8175 27.637 28.9992 -34.1073 -16.3293 -5.23745 -6901 4 52.1753 27.4604 29.7292 18.9476 13.4611 -8.14668 -6902 4 53.5412 28.184 29.256 17.7352 16.912 19.7012 -6903 6 33.3098 15.691 11.3293 10.3241 5.44869 29.2776 -6904 4 33.5439 15.9761 12.2647 -8.49351 -12.0766 -30.078 -6905 4 32.4682 16.1118 11.1139 -1.38634 1.49203 3.14806 -6906 6 20.3823 26.792 27.4754 10.6616 14.7237 17.2289 -6907 4 19.6846 27.4135 27.2507 -4.69437 -0.849554 -6.03625 -6908 4 20.895 27.2908 28.1563 -10.3656 -18.3754 -15.2612 -6909 6 8.54404 2.05454 14.1651 1.1449 13.7122 2.29602 -6910 4 8.12946 1.19872 14.2191 -6.02545 -13.9865 0.607463 -6911 4 8.06484 2.58201 14.8308 4.74922 -3.38849 -5.44478 -6912 6 40.1105 7.56396 40.6794 -0.469697 6.72942 -1.63666 -6913 4 39.7195 8.28533 41.2425 20.0171 -18.0739 -7.27063 -6914 4 40.8018 7.03949 41.1472 -13.6242 13.5344 3.71207 -6915 6 6.897 6.83213 10.7811 7.71606 15.0782 -3.77655 -6916 4 7.19774 7.75246 10.6132 -6.74961 -17.2243 4.00207 -6917 4 7.00156 6.6927 11.7358 -2.06706 0.697676 -4.80225 -6918 6 31.2469 6.57665 20.133 15.2512 -44.8317 5.05575 -6919 4 30.6435 5.99888 20.634 -3.65198 3.16249 1.16613 -6920 4 30.7682 7.35458 19.9689 -22.0921 35.6742 -6.0398 -6921 6 54.5384 21.0446 27.3066 23.2273 -48.3206 40.5729 -6922 4 0.0992734 20.2122 27.4067 -21.2046 24.987 7.15799 -6923 4 54.6588 21.2398 26.4073 -2.82622 20.9035 -45.5707 -6924 6 4.74298 23.1434 16.2203 -30.2995 19.4891 -12.6787 -6925 4 4.36556 24.0555 16.215 7.46998 -18.526 0.357752 -6926 4 5.49124 23.2367 16.7883 23.1348 -5.45784 14.6166 -6927 6 25.5466 11.0338 14.8277 10.3359 0.700294 4.3384 -6928 4 26.1246 10.3443 15.2243 -8.70528 11.4294 -11.7317 -6929 4 25.9183 11.8873 15.0941 -0.865353 -5.34287 -3.41216 -6930 6 41.1962 41.784 29.9422 -30.017 -5.50367 -10.8152 -6931 4 40.9141 40.905 29.5845 10.5201 22.1914 8.67773 -6932 4 40.3904 0.453034 29.9085 19.4524 -11.6054 2.3136 -6933 6 52.2783 15.2862 41.6211 7.07203 -4.19206 -10.8941 -6934 4 51.9431 15.9476 0.307056 -1.67854 11.1856 8.97788 -6935 4 51.5699 14.6487 41.5543 -8.05659 -11.9472 -4.98288 -6936 6 37.758 21.7866 37.8526 10.4754 12.291 4.40187 -6937 4 37.8833 20.8525 37.7239 2.64231 -18.5298 -3.43162 -6938 4 38.1062 21.9123 38.7409 -0.189838 4.59809 2.45253 -6939 6 23.846 9.72877 27.5599 -20.0483 -53.0743 -18.3837 -6940 4 23.7508 8.9538 26.878 9.78252 41.145 35.6193 -6941 4 23.2758 9.50619 28.3397 9.82275 7.24107 -18.911 -6942 6 43.0179 28.0371 32.8168 -8.27592 12.0689 -0.875134 -6943 4 42.8326 27.1827 33.2413 14.9994 1.75302 -2.99965 -6944 4 43.9358 28.1723 32.5349 -8.32605 -13.2452 6.20231 -6945 6 34.1493 21.223 11.895 -6.4617 -26.4803 6.62596 -6946 4 33.7114 20.3967 12.2433 5.74917 23.5867 -12.2191 -6947 4 33.6625 21.5015 11.0997 -1.34318 -2.64619 5.02085 -6948 6 10.5048 31.8203 10.0934 3.12763 27.8567 -5.97475 -6949 4 10.8893 32.6663 10.3856 -2.25958 -16.5293 2.97323 -6950 4 10.042 32.0955 9.27903 1.62317 -10.8132 6.61598 -6951 6 35.8582 37.1311 22.1219 17.442 6.8165 -15.3109 -6952 4 36.7754 37.4644 22.0121 -13.2022 -8.29883 -6.66499 -6953 4 35.6795 37.2674 23.0383 -11.5038 0.0185045 25.2366 -6954 6 27.2889 4.59659 27.4585 -59.4895 -12.2555 32.2126 -6955 4 27.8503 4.63259 28.2407 7.94553 1.46958 -1.61102 -6956 4 26.3513 4.38137 27.8533 49.6255 8.2673 -26.6042 -6957 6 39.0071 22.2889 10.6559 -18.7539 6.55471 8.53947 -6958 4 39.6145 22.0219 9.97399 11.0637 -4.63202 -10.5583 -6959 4 38.132 22.2267 10.2407 1.98377 -6.13574 3.6668 -6960 6 30.7475 39.195 10.9378 13.4076 -25.4475 -2.13886 -6961 4 31.7135 39.1987 10.9202 1.84768 25.2682 1.10777 -6962 4 30.6542 38.2342 10.8274 -15.9936 9.0572 -1.5893 -6963 6 44.6038 26.9469 2.19596 -3.02312 -2.7981 0.496435 -6964 4 44.789 26.0668 2.58199 4.34993 15.1048 -14.5643 -6965 4 45.3477 27.2287 1.63769 1.54159 -5.20589 8.29494 -6966 6 23.7761 14.5574 26.4892 -1.60295 28.5342 -20.4107 -6967 4 23.6176 15.1119 25.659 4.49284 -25.3407 28.839 -6968 4 23.2395 13.7622 26.4238 -2.18231 -2.53609 -2.40557 -6969 6 38.3444 13.3746 39.6516 36.4054 -1.80378 3.51049 -6970 4 39.1202 13.8805 40.0461 -33.1028 -11.4882 -12.1373 -6971 4 37.5326 13.855 39.8351 -2.35218 5.60767 6.28087 -6972 6 17.8972 17.2344 29.4073 9.50877 -9.96512 10.1834 -6973 4 17.6974 16.8197 28.5593 -3.90288 0.722299 -3.3346 -6974 4 17.259 17.9348 29.5179 -13.7448 8.39178 0.729907 -6975 6 17.4263 29.84 9.91085 4.63967 13.4244 18.4952 -6976 4 16.5241 29.7155 9.63978 -6.68442 -7.79832 -10.641 -6977 4 18.0121 29.6473 9.18714 6.17675 -5.88453 -9.84082 -6978 6 35.6257 6.05657 19.614 -2.53427 -7.67526 1.74575 -6979 4 35.1442 5.56448 18.9178 7.07991 15.7277 0.668344 -6980 4 35.8526 6.94177 19.2847 -2.44106 -6.98166 -5.33042 -6981 6 18.6731 22.2952 17.5195 -8.35574 4.99894 -0.254983 -6982 4 17.7298 22.4259 17.6349 -7.1371 0.699885 10.6378 -6983 4 18.7532 22.3981 16.578 9.97204 2.32932 -16.3296 -6984 6 20.0126 3.82895 32.2846 -5.38506 7.6032 10.998 -6985 4 19.7316 4.05659 31.3951 3.95105 0.959407 -6.40709 -6986 4 20.9087 3.45699 32.2166 -3.62371 1.18893 -2.87546 -6987 6 5.48106 6.97474 8.11911 -13.3431 -28.5569 -4.23146 -6988 4 5.76723 7.87539 8.05126 9.5873 19.9723 5.64469 -6989 4 5.84003 6.56862 8.91875 4.365 4.20298 7.41399 -6990 6 44.2055 20.527 25.594 -36.5422 -32.7496 -22.1294 -6991 4 44.4952 21.1964 26.2048 27.2712 12.1663 0.509182 -6992 4 44.8136 20.1687 24.9192 13.264 16.717 13.5958 -6993 6 43.9676 36.9898 17.8707 9.43563 13.9581 11.3899 -6994 4 44.6425 37.4866 17.3506 -13.9886 -14.2814 1.04264 -6995 4 43.5166 36.316 17.3518 1.57776 -4.71986 -9.07493 -6996 6 34.624 10.1249 16.2553 -3.80507 -0.870494 -23.8528 -6997 4 34.4029 10.0232 15.2766 7.60873 7.05542 33.3523 -6998 4 34.6485 11.0843 16.4397 0.136369 -4.79707 -6.11079 -6999 6 23.6588 3.43472 1.31587 2.0947 2.20184 -10.1691 -7000 4 23.5283 2.45383 1.23665 3.68597 29.2686 -10.0862 -7001 4 23.7829 3.95594 0.465507 -5.48879 -27.0668 21.3429 -7002 6 33.408 38.9514 5.0951 12.9752 29.4037 8.61745 -7003 4 33.0296 38.079 4.95882 -18.4714 -2.71742 3.9597 -7004 4 32.7559 39.6696 5.33685 4.56028 -29.4715 -9.24259 -7005 6 22.5612 32.5054 35.7914 -7.59797 17.3543 -6.08959 -7006 4 23.434 32.1498 35.9581 8.59623 -0.183209 1.98348 -7007 4 22.6598 33.4814 35.6698 2.01652 -18.126 2.22848 -7008 6 32.4197 37.2669 13.8205 20.7322 22.1346 -9.91782 -7009 4 31.6112 36.8955 13.5272 -29.3682 -10.7083 -8.61391 -7010 4 32.7793 36.5983 14.3861 8.71878 -17.2052 10.8721 -7011 6 52.6061 12.7509 39.5955 -8.08982 -5.36768 -0.728302 -7012 4 53.2357 13.3696 39.2333 6.80499 9.05338 -6.44134 -7013 4 53.0752 12.2813 40.2869 4.34006 -2.9945 3.85342 -7014 6 28.8406 14.5639 1.22393 13.2702 13.2594 -7.07732 -7015 4 28.2547 13.832 1.29641 -8.98786 -23.9917 -3.18497 -7016 4 28.3081 15.2705 1.57856 0.691728 8.20301 3.76967 -7017 6 1.46371 32.4171 23.3808 -12.1734 -25.5645 13.9938 -7018 4 1.52421 31.5049 23.0145 7.51613 19.861 -1.66683 -7019 4 1.90409 33.05 22.8306 10.4998 5.06095 -20.3958 -7020 6 54.3326 23.3294 28.9734 2.61182 15.3833 -1.51239 -7021 4 54.2696 22.9227 29.8387 -0.130455 -4.55084 5.05008 -7022 4 54.4476 22.6226 28.3359 -0.0534198 -9.82677 -0.516761 -7023 6 14.3165 12.143 35.6759 -19.2415 -8.81627 -0.503167 -7024 4 14.3877 12.7977 36.3527 0.233596 18.6669 11.2481 -7025 4 15.2077 11.8775 35.5438 25.0768 -7.98239 -7.51161 -7026 6 18.9926 6.51479 41.2701 -28.9824 -29.6237 1.81046 -7027 4 18.266 5.84223 41.3522 13.7729 17.3268 -5.20094 -7028 4 19.3309 6.57432 0.258232 8.64619 7.1183 4.95474 -7029 6 5.3156 17.8978 20.3375 -21.1545 16.5991 3.60383 -7030 4 4.72623 18.3448 19.6879 4.29754 -5.05212 8.41069 -7031 4 4.82948 17.9368 21.1935 9.1049 1.98802 -15.8618 -7032 6 24.7216 34.9676 30.1666 -3.07326 -14.2394 -14.8574 -7033 4 24.8542 35.9126 30.1802 4.14387 12.0412 4.3338 -7034 4 24.7023 34.7085 29.2239 -0.0690866 8.67132 12.606 -7035 6 31.8759 4.61762 18.1838 16.2734 -6.94643 -1.61547 -7036 4 31.7767 5.32612 18.8146 -0.693712 9.66586 8.6442 -7037 4 30.9961 4.53608 17.8264 -12.7431 -2.99311 -6.3499 -7038 6 8.70679 17.4876 5.93376 -7.2594 15.0659 3.57914 -7039 4 7.94553 18.1226 5.84491 19.4684 -9.25267 2.2845 -7040 4 9.55198 17.9922 5.98984 -15.4384 -2.82622 -0.0668602 -7041 6 29.8338 10.9771 14.4736 2.85583 -20.8689 4.17621 -7042 4 29.3487 11.4359 13.7779 -2.35633 12.0716 2.99849 -7043 4 29.9333 11.5067 15.2792 -5.11986 9.15119 -1.36774 -7044 6 48.7176 10.2992 32.5766 37.752 -4.2965 -7.5649 -7045 4 48.6861 9.98692 33.5109 4.36425 8.41374 -15.5521 -7046 4 49.6689 10.1741 32.2115 -43.6207 3.75412 17.6406 -7047 6 8.33261 15.6868 37.8739 25.2856 -16.7599 -34.932 -7048 4 8.10095 16.0156 38.719 -17.2941 17.7495 29.2541 -7049 4 7.84865 16.1686 37.1872 -4.77393 6.83012 10.4818 -7050 6 50.4 3.07893 17.326 6.75193 2.54677 -10.5223 -7051 4 49.8476 3.08454 16.5614 0.0537611 0.514048 -24.7797 -7052 4 49.7563 3.22783 17.9993 -5.52918 6.4504 35.6689 -7053 6 14.6925 38.3995 10.8943 -10.4545 -11.2686 -1.07851 -7054 4 14.3539 38.6226 11.7634 0.533319 14.8424 10.3104 -7055 4 14.2274 37.5681 10.7419 5.82896 -0.087222 -8.72758 -7056 6 34.1157 6.37736 10.827 20.4112 17.5403 9.63945 -7057 4 34.1356 7.15575 10.2337 -4.79421 -13.4894 2.09643 -7058 4 34.9392 6.47467 11.3721 -17.4677 -2.57189 -8.67394 -7059 6 7.16428 37.5549 17.6272 35.8206 -6.94283 1.42456 -7060 4 8.17672 37.4379 17.5039 -45.4701 3.04153 9.54579 -7061 4 6.9329 37.0909 18.4673 4.48983 7.2965 -12.9876 -7062 6 51.5173 11.3068 16.7982 -29.6345 12.4732 -19.9425 -7063 4 52.2329 10.8476 17.1999 24.0623 -16.8016 7.00331 -7064 4 51.4947 11.1437 15.8343 5.46468 -1.37513 9.57578 -7065 6 15.6604 8.64432 3.1895 3.55656 -13.2601 -18.336 -7066 4 15.3831 9.26805 3.84437 -11.3932 20.6181 15.5674 -7067 4 16.2117 8.03967 3.68493 6.317 -8.49687 -0.892024 -7068 6 5.4241 21.4549 11.925 7.11554 10.6798 -7.02681 -7069 4 5.33432 22.3429 11.4717 -4.65036 -17.889 17.4658 -7070 4 4.77116 21.2815 12.6313 -0.367847 15.68 -7.67111 -7071 6 50.1893 24.0442 37.9781 -13.1484 0.855785 -17.0816 -7072 4 49.5179 24.1845 37.2801 8.13829 0.111989 16.6227 -7073 4 50.739 23.3224 37.6715 2.2014 -1.01472 3.1635 -7074 6 39.7382 11.2507 31.6977 23.6406 7.23187 -3.58891 -7075 4 40.4046 11.8538 31.2923 -18.8268 -10.2166 5.80002 -7076 4 38.8713 11.6238 31.5229 -1.54541 8.70996 -4.13134 -7077 6 26.6923 10.8294 20.5841 1.50171 17.3672 -0.163562 -7078 4 26.3063 11.3901 21.299 5.00814 -17.7696 -11.6362 -7079 4 26.5519 9.91114 20.8376 -1.99146 -0.979444 5.82041 -7080 6 12.5744 17.5779 18.1705 9.62673 -31.396 -11.9521 -7081 4 12.2909 16.663 17.987 19.11 1.74385 -8.92353 -7082 4 11.8345 17.8227 18.6757 -30.0259 29.7826 25.4081 -7083 6 47.7778 31.6094 17.3292 -7.10666 -17.038 -8.06235 -7084 4 48.347 31.2547 18.014 2.28217 1.30733 4.94459 -7085 4 47.3418 30.8212 16.9416 1.10301 17.3121 -1.07651 -7086 6 1.06524 3.39018 18.5298 -14.3894 10.3619 10.5476 -7087 4 1.40487 3.81402 19.3241 14.4239 4.64695 -0.395869 -7088 4 0.13491 3.28998 18.7837 -2.56119 -4.67364 -10.5163 -7089 6 26.5953 20.387 15.3121 4.86749 -24.5982 -5.101 -7090 4 27.0693 19.5476 15.0746 -6.18915 17.8108 6.48343 -7091 4 25.6882 20.059 15.4501 7.15985 4.40883 -1.86988 -7092 6 42.0068 3.03472 36.7639 -8.02624 -14.3838 3.82934 -7093 4 41.5138 2.21919 36.6422 -1.8797 -9.24856 -19.1073 -7094 4 41.9017 3.12445 37.6992 6.42334 14.3979 20.8626 -7095 6 39.3283 22.4329 33.1866 16.7976 22.9312 16.1168 -7096 4 39.617 22.6043 34.1233 -9.1007 -15.4059 -24.4851 -7097 4 39.2996 23.351 32.8579 -1.9326 -13.3537 -7.72798 -7098 6 18.5014 34.9723 11.9503 -40.872 8.93582 -22.0032 -7099 4 19.313 34.895 12.3871 37.9781 -3.12322 33.9295 -7100 4 17.8134 35.1232 12.6133 -0.0311416 1.40314 8.7121 -7101 6 22.862 14.1089 0.203393 17.2545 -2.37957 19.5806 -7102 4 23.1276 14.8054 41.5255 0.219481 9.03583 -13.3452 -7103 4 23.4003 14.3117 0.999915 -8.23864 -6.67581 -7.59618 -7104 6 30.9898 16.6325 33.7811 -26.24 4.82889 -18.7278 -7105 4 30.4991 16.9295 32.9906 -1.06726 -7.21679 15.5744 -7106 4 31.8724 16.8786 33.545 20.2345 1.84197 6.64809 -7107 6 28.4142 35.5086 5.55132 5.25795 11.5001 -0.86936 -7108 4 29.133 34.8901 5.6729 7.87573 -11.0207 0.32142 -7109 4 28.8444 36.3678 5.44284 -5.96253 -1.38672 0.306744 -7110 6 2.06178 31.4487 10.6522 7.7724 2.5252 5.43788 -7111 4 2.46787 32.1741 10.1582 1.48866 -1.05725 0.00513454 -7112 4 1.12423 31.5492 10.4902 -10.7705 -1.69396 -4.48797 -7113 6 5.96168 9.75465 21.3469 -3.89643 8.81348 -50.5901 -7114 4 6.28958 10.5041 20.7544 -9.04712 -29.7196 22.9081 -7115 4 5.37557 9.21645 20.7377 15.5825 17.9805 22.1648 -7116 6 24.7784 26.6095 2.66066 11.1746 -2.24162 5.28408 -7117 4 23.9956 26.7754 2.10108 -2.29597 -10.0774 9.56872 -7118 4 24.6953 25.8682 3.30791 -10.2989 11.7132 -14.8816 -7119 6 45.7373 4.24983 18.6143 27.3178 -0.763462 -4.2154 -7120 4 46.5067 4.85242 18.4954 -19.0177 -2.03966 3.70694 -7121 4 46.1538 3.38182 18.4484 -14.6954 3.88493 3.6473 -7122 6 4.46307 0.776675 15.9004 -0.0751459 19.7124 -7.24544 -7123 4 4.28648 41.7452 15.8506 7.90268 -11.6504 4.49907 -7124 4 5.34722 0.941656 16.2766 -7.84 -9.44871 -1.18019 -7125 6 2.43543 19.4835 25.3975 -8.02289 7.34849 22.5637 -7126 4 1.8039 19.0427 26.0095 9.34608 -2.48106 -16.7091 -7127 4 2.63666 18.9452 24.6346 -2.8512 -10.1259 -3.82486 -7128 6 40.5893 8.48301 5.11314 -1.35782 -12.8068 -2.32465 -7129 4 40.7524 9.27543 5.61119 -3.30667 17.7402 10.4879 -7130 4 41.4486 8.05286 5.16027 3.34022 -8.8045 -8.92488 -7131 6 49.3107 22.3512 41.5276 -10.6582 56.3201 6.76971 -7132 4 48.577 22.7852 41.0387 15.264 -8.60422 5.01334 -7133 4 49.2575 21.458 41.2835 -0.448838 -46.7272 -11.6484 -7134 6 0.358901 40.9209 20.5803 -19.8443 -5.20423 -21.0143 -7135 4 0.209912 39.9476 20.5616 0.00996972 10.506 -0.843682 -7136 4 54.6254 41.351 20.0384 15.1519 -13.0167 14.2251 -7137 6 34.868 15.3449 38.0159 -4.77394 11.9701 -21.6163 -7138 4 34.21 16.0699 37.905 14.1938 -11.5268 -7.28032 -7139 4 35.478 15.4115 37.2329 -18.0572 6.07255 16.3223 -7140 6 7.76403 26.0071 29.8556 5.34791 -0.957035 4.21351 -7141 4 8.62364 26.4528 30.0224 -8.82329 -12.5157 -0.945539 -7142 4 7.90301 25.0604 30.0866 1.23738 19.4493 -2.25897 -7143 6 40.714 22.798 20.4449 30.2403 28.6605 -20.1452 -7144 4 41.3584 23.4838 20.081 -22.4198 -29.1089 11.875 -7145 4 40.2102 23.3285 21.0558 -12.075 4.18803 12.4472 -7146 6 37.6868 25.6422 36.0641 6.66209 -5.59755 13.6904 -7147 4 38.2808 24.8923 36.0269 4.65063 -3.44496 7.57849 -7148 4 37.3429 25.6351 35.1859 -16.0941 8.70932 -25.1352 -7149 6 5.45062 23.9828 10.2587 5.16865 5.9624 5.01697 -7150 4 5.97911 23.8188 9.45867 -6.21725 4.51436 8.29683 -7151 4 5.82702 24.8173 10.6422 -10.2102 -24.7042 -13.9856 -7152 6 48.3972 21.0585 38.1887 36.079 14.8531 -15.9941 -7153 4 48.9083 20.6932 38.9203 -9.15007 -3.24726 4.47194 -7154 4 49.1186 21.3212 37.5505 -33.8036 -6.43701 14.9947 -7155 6 15.2894 25.0118 3.53737 -15.5341 -16.8072 10.9824 -7156 4 15.3523 24.0463 3.54635 7.80908 -0.218079 -10.1213 -7157 4 14.6524 25.152 4.25109 -0.971191 12.1275 -1.41446 -7158 6 46.3973 40.2818 20.0864 -5.10979 -28.8528 0.810189 -7159 4 46.7099 39.3289 20.1836 -4.69047 35.7762 -3.66479 -7160 4 47.1343 40.8792 20.2285 11.4236 3.93541 -0.385178 -7161 6 34.6613 36.4755 0.335066 -24.7851 30.4749 -21.6933 -7162 4 34.8743 36.0541 1.15687 -4.43901 -4.57192 24.0914 -7163 4 33.7851 36.9546 0.454416 30.1492 -20.7825 2.99091 -7164 6 52.5881 7.99834 30.4195 9.51271 -12.4348 0.483116 -7165 4 52.1042 8.76616 30.7719 -8.49213 -7.21741 -10.9068 -7166 4 52.0722 7.46347 29.7764 0.520668 12.6171 10.1624 -7167 6 32.0714 3.86484 29.4697 -9.7538 -17.9077 -31.6249 -7168 4 31.6702 2.97314 29.6052 7.93851 20.6113 2.31556 -7169 4 32.0839 3.94733 28.4741 0.539668 -3.17995 32.4864 -7170 6 20.3786 17.8365 28.6466 -12.59 16.0252 -12.2548 -7171 4 19.5397 17.5939 29.0718 10.0495 1.57584 1.91854 -7172 4 20.0545 18.3008 27.843 10.529 -6.18443 10.1885 -7173 6 30.4085 41.1704 41.0135 6.18506 -3.22706 -14.2809 -7174 4 30.53 40.7341 40.1581 -10.3332 2.11637 -0.589059 -7175 4 31.2241 40.9477 41.4498 10.7912 2.88832 12.9661 -7176 6 35.4567 32.8541 27.9296 20.1033 20.3116 -25.2142 -7177 4 35.1103 33.2872 28.7174 -1.27312 4.66796 4.01126 -7178 4 35.9087 33.5476 27.342 -15.0191 -24.2746 21.4934 -7179 6 14.3794 6.67806 12.7301 -1.9413 28.2373 -4.00169 -7180 4 15.2373 6.26429 12.8613 2.01848 -2.11516 -0.858514 -7181 4 14.5332 7.65903 12.7289 -3.54891 -27.4927 -2.87641 -7182 6 41.884 41.5441 20.3292 17.5267 3.97767 -7.39307 -7183 4 42.6467 41.3531 19.7473 -6.80228 5.43899 6.41045 -7184 4 41.2989 40.8038 20.1922 -8.54368 -4.96293 -3.75352 -7185 6 46.4016 22.5784 8.86191 7.75251 -10.6521 7.11129 -7186 4 45.8476 21.8716 8.52158 -12.3576 2.35246 -8.51817 -7187 4 47.0146 22.0703 9.39636 1.75986 6.35736 5.22437 -7188 6 17.4049 20.6472 13.8946 9.03444 14.2526 1.49725 -7189 4 17.6929 21.5842 14.0543 -8.3446 -25.4959 -7.46489 -7190 4 17.3265 20.4984 12.9333 2.034 6.01629 5.63707 -7191 6 8.18883 9.49722 13.352 -36.2403 7.79383 -0.838203 -7192 4 7.38606 10.0563 13.5919 32.9103 -12.129 -3.09847 -7193 4 9.02271 9.90793 13.6245 -5.40631 9.4956 5.41337 -7194 6 7.5857 14.8045 29.5864 0.660595 8.18183 -2.22865 -7195 4 7.08502 14.4366 30.3218 -1.52277 2.83209 3.37304 -7196 4 7.02502 15.474 29.1565 2.15616 -5.78955 1.98978 -7197 6 29.5787 39.2199 22.642 -23.9064 2.77655 4.40715 -7198 4 29.7923 38.7231 23.4359 12.3113 -5.95711 5.92816 -7199 4 30.3289 39.2945 22.0576 16.6647 -3.01011 -3.30282 -7200 6 19.7261 28.8048 8.43629 7.07867 10.1416 -1.30332 -7201 4 19.5094 27.8711 8.56662 5.24428 2.50367 -2.7317 -7202 4 20.6808 28.8901 8.64157 -12.3267 -4.04756 -0.658665 -7203 6 20.0918 21.6433 25.9098 -22.8378 18.9737 -2.62589 -7204 4 20.6828 21.9331 26.6394 -14.5657 0.991195 -11.6344 -7205 4 19.2872 22.2354 25.9429 24.6623 -16.2361 5.64257 -7206 6 12.7798 16.1171 22.7918 2.83481 -1.66518 -8.4999 -7207 4 12.1052 16.761 22.5802 -5.26913 11.1277 0.000470885 -7208 4 12.4145 15.3113 22.3987 5.67676 1.62415 3.74644 -7209 6 7.09341 27.2127 17.9852 -17.6727 17.6357 -2.43489 -7210 4 7.71878 26.5086 17.8851 15.5779 -18.3258 -2.50971 -7211 4 7.24623 27.7931 17.2297 2.82114 0.873921 -0.89624 -7212 6 32.4121 8.69011 34.8574 -11.3856 31.068 25.9423 -7213 4 32.686 9.10208 35.716 -2.62469 -14.8204 -24.695 -7214 4 31.4981 9.04705 34.7249 20.8054 -13.4625 -4.53694 -7215 6 50.3489 28.2274 17.5408 2.96892 -19.9668 3.87059 -7216 4 50.2931 27.3328 17.9381 -3.71715 13.2344 -0.552608 -7217 4 51.012 28.0828 16.8476 -2.81747 8.99858 -3.49204 -7218 6 15.6752 32.1523 25.7996 -24.1097 -1.02752 -8.0065 -7219 4 16.4469 32.5721 26.1513 19.1192 7.47953 7.03048 -7220 4 15.1241 32.8942 25.4834 5.39501 -5.59697 3.80799 -7221 6 41.2942 22.0009 29.6469 23.8016 -11.3242 12.4312 -7222 4 40.6197 22.5451 29.2897 -20.6362 19.5621 -14.8771 -7223 4 40.8321 21.2604 30.0334 -1.27155 -6.80964 4.85239 -7224 6 24.5512 12.7478 8.87624 0.539479 -2.56763 -16.1827 -7225 4 24.2317 13.5544 9.29419 1.48927 0.294937 0.678301 -7226 4 24.2485 12.8104 7.9491 4.47413 -5.17195 11.4459 -7227 6 47.3043 20.1171 10.4067 20.0451 13.2477 8.4905 -7228 4 48.2327 20.3756 10.3708 -0.951507 4.56311 9.88278 -7229 4 47.2371 19.5522 9.64912 -14.6685 -17.4861 -17.2657 -7230 6 17.6686 14.2187 29.9453 7.31834 -6.07886 -8.28437 -7231 4 16.8567 14.6777 30.1627 -12.3548 11.6861 -0.426412 -7232 4 18.1621 14.7508 29.3045 -6.68566 0.573373 4.02912 -7233 6 21.3468 34.5864 28.5404 1.3464 21.7174 -7.002 -7234 4 21.5866 35.4807 28.2285 -6.04705 -7.23946 1.73439 -7235 4 21.8012 34.5133 29.372 6.90897 -8.71765 12.9147 -7236 6 35.0919 4.05058 4.01374 -15.5825 9.30565 11.5721 -7237 4 34.2387 3.74233 4.43927 22.4566 16.9059 -11.4445 -7238 4 35.1406 5.04582 3.93988 -11.3656 -25.7387 7.52347 -7239 6 29.9083 8.58745 22.5962 -15.8002 1.46007 -28.7439 -7240 4 29.4293 8.33193 21.7391 23.5037 3.33824 36.5279 -7241 4 30.4512 7.83881 22.8901 -6.5033 3.48596 -7.29863 -7242 6 9.80484 32.9578 15.933 -3.40746 -8.77641 -12.0557 -7243 4 9.78146 31.9986 16.1651 13.0086 23.7442 4.23133 -7244 4 10.4547 33.4728 16.4465 2.19651 -19.1398 5.78046 -7245 6 24.9207 14.2283 32.5839 15.8568 -2.03515 22.8032 -7246 4 25.4679 14.491 33.3602 -10.7028 -6.65113 -14.6818 -7247 4 24.5651 15.0495 32.2637 -5.99659 7.67207 -7.30645 -7248 6 49.6599 21.9679 26.2292 42.3899 27.0609 3.31449 -7249 4 50.4576 21.5325 26.6526 -24.3124 13.7703 -9.69582 -7250 4 49.9726 22.89 25.9802 -16.6307 -33.6109 8.97028 -7251 6 39.2146 29.6271 28.776 1.2649 -6.72815 -4.66326 -7252 4 39.3113 29.0399 29.5368 -1.10705 1.67847 4.24024 -7253 4 39.5646 29.0864 28.052 -0.275695 2.9096 0.748968 -7254 6 50.692 34.7829 39.7485 29.9384 -8.83369 -9.14761 -7255 4 51.6379 34.6172 39.5245 -10.9597 10.0847 13.0799 -7256 4 50.284 34.1892 39.1195 -14.598 -6.88033 -5.74908 -7257 6 29.205 20.8761 19.5187 12.6622 -8.88768 18.517 -7258 4 30.1458 21.1462 19.5468 -10.0278 2.51211 -7.13483 -7259 4 28.7621 21.2804 18.7794 -5.02457 12.868 -15.5739 -7260 6 45.8413 1.41619 21.3894 -25.1775 13.0352 -19.0829 -7261 4 45.002 1.0285 21.6935 10.996 -3.183 3.42833 -7262 4 46.5512 0.981978 21.8333 16.3199 -17.0363 14.4799 -7263 6 26.0942 5.84138 12.9755 -8.81801 -1.79204 -2.94978 -7264 4 26.5644 5.00851 12.8396 1.48472 -6.22175 2.21387 -7265 4 25.1658 5.65249 12.7519 4.56693 -2.33816 -1.27821 -7266 6 9.00853 19.0479 23.7214 20.279 18.3012 -13.9253 -7267 4 8.07192 18.8993 23.8406 -12.3386 2.44029 -0.494901 -7268 4 9.09287 19.8709 23.17 -6.05991 -16.4473 11.9144 -7269 6 47.699 14.1778 40.0244 8.37408 5.46764 -8.11648 -7270 4 48.526 14.369 39.5365 -13.6583 -0.0280305 9.55934 -7271 4 47.2742 15.0291 40.2237 1.48315 -6.20176 -4.56159 -7272 6 47.9891 19.7944 0.501942 -52.5058 -34.5194 5.9677 -7273 4 48.5389 19.8149 1.25758 31.4646 9.24384 22.8657 -7274 4 47.3233 19.1101 0.79406 16.1078 24.936 -21.6052 -7275 6 27.1644 39.5895 31.4222 -35.4984 -42.2857 -13.2745 -7276 4 26.8828 40.2644 32.0188 2.45392 19.408 13.0965 -7277 4 26.334 39.0158 31.3353 32.2444 14.87 -2.1562 -7278 6 20.718 15.281 27.2921 -20.5288 29.0824 -25.1338 -7279 4 19.7916 15.5288 27.1303 0.0426049 -12.6319 11.5337 -7280 4 21.1251 16.0883 26.9354 13.4588 -8.377 2.43969 -7281 6 53.2931 3.12982 19.6939 21.059 35.3193 6.93312 -7282 4 52.5111 3.68486 19.642 -0.600406 9.66435 -1.15328 -7283 4 52.9649 2.26115 19.6482 -6.97037 -43.0252 -2.92507 -7284 6 40.7577 33.3874 24.037 12.7176 -1.25655 15.6318 -7285 4 41.575 33.1492 24.5319 -10.6485 3.51614 -11.0419 -7286 4 40.1417 32.64 24.1417 6.01104 2.31945 0.566227 -7287 6 50.2034 37.8915 21.3784 34.5696 42.4783 -9.46203 -7288 4 50.977 37.3667 21.5595 20.6596 -6.9612 4.63629 -7289 4 49.5128 37.3071 21.51 -51.1752 -39.6198 7.18684 -7290 6 41.3315 2.34663 21.9881 -5.34027 -0.787955 22.4754 -7291 4 41.3778 2.5308 21.0564 -4.51788 5.59338 -11.8441 -7292 4 40.4369 2.61524 22.307 16.348 -5.18373 -12.1741 -7293 6 3.68887 21.2797 14.3363 -13.7249 24.7693 -29.296 -7294 4 4.1389 21.9084 14.895 6.09004 12.6164 9.74183 -7295 4 3.85532 20.4521 14.7268 10.1618 -35.5887 19.7816 -7296 6 34.2749 11.1621 36.6211 6.86722 -26.3475 -8.98455 -7297 4 34.1457 10.3739 37.2084 1.76529 18.7936 -6.49638 -7298 4 34.0208 11.9523 37.0887 -10.0392 4.20616 19.2695 -7299 6 24.047 21.9251 23.4534 9.96695 -9.01801 9.45846 -7300 4 24.1056 21.4984 22.592 0.489969 -1.19981 -5.95122 -7301 4 24.6049 21.3417 24.0221 -10.3198 12.7259 -7.25629 -7302 6 18.8859 0.355593 4.41703 6.91373 -0.488994 13.8226 -7303 4 18.8848 41.346 4.15992 -3.4937 -3.21088 -8.69706 -7304 4 19.4141 0.350836 5.23016 -4.89519 7.76131 -7.17368 -7305 6 1.61894 7.82812 17.7388 11.0013 -2.20401 0.0755565 -7306 4 1.69825 6.91132 17.4299 0.598176 5.44338 0.144381 -7307 4 0.751076 7.92867 18.1276 -6.88769 -1.80246 0.772288 -7308 6 9.88357 31.5477 26.4865 20.7425 -47.9078 -25.9665 -7309 4 9.77347 30.8406 25.7562 4.13802 32.2768 29.9214 -7310 4 9.16637 32.1481 26.416 -28.5637 22.827 -5.6847 -7311 6 46.9801 33.0031 20.3665 8.92807 -2.6835 25.0439 -7312 4 47.1906 32.5959 21.2783 -12.5238 7.50902 -41.0074 -7313 4 46.473 32.3868 19.8049 3.08737 -2.68707 12.6131 -7314 6 49.5381 29.29 21.3848 5.35466 4.48298 6.61079 -7315 4 50.3596 28.8237 21.4263 11.6576 -22.6485 -14.6982 -7316 4 49.6544 29.7814 22.1942 -19.8316 15.0268 8.13943 -7317 6 13.5135 31.8933 19.1567 20.4477 19.0535 18.7588 -7318 4 12.9544 32.0303 19.9484 11.7182 -3.51681 -10.2564 -7319 4 14.3688 32.3555 19.4049 -26.6747 -15.4769 -10.5401 -7320 6 46.6242 34.0973 16.9259 3.25439 -22.1556 18.333 -7321 4 46.8986 34.1178 16.0034 3.18051 -0.659651 -5.23437 -7322 4 46.9878 33.2447 17.2966 -6.98741 23.2488 -14.973 -7323 6 19.7685 39.5238 2.42723 -1.93992 9.56528 -9.07466 -7324 4 20.504 40.1421 2.55739 -2.20075 -2.41675 -0.557551 -7325 4 19.2228 39.9982 1.75695 7.86662 -14.3322 13.7479 -7326 6 16.5372 9.39399 28.3106 5.81076 4.55242 0.698497 -7327 4 16.5228 10.3583 28.3138 -6.10914 3.2393 2.1867 -7328 4 17.4567 9.2086 28.1181 8.68803 -11.6531 -1.09187 -7329 6 3.04764 33.3834 8.9498 9.15555 8.47462 14.2626 -7330 4 2.34782 34.0603 8.86882 1.18173 -6.7492 -12.1187 -7331 4 3.16543 32.8691 8.13996 -9.91006 6.39371 -6.60301 -7332 6 49.6799 28.314 0.198287 -24.1009 9.02482 3.02524 -7333 4 50.5864 28.3416 41.8577 25.8797 -1.22492 -6.2647 -7334 4 49.539 27.5375 0.746128 -0.431885 -1.84115 5.43874 -7335 6 1.41501 6.84656 30.491 -4.80497 13.9866 22.936 -7336 4 1.80101 7.66454 30.873 3.64878 -10.2221 -13.1962 -7337 4 0.770406 6.61566 31.1883 9.6026 -0.286793 -13.8716 -7338 6 19.7721 9.41455 33.714 -8.86768 10.4812 -29.5452 -7339 4 19.9336 8.45599 33.7164 -2.74186 3.51224 -8.50186 -7340 4 19.4649 9.70036 32.7878 8.54711 -12.9815 34.2723 -7341 6 26.1689 11.9219 3.60877 17.3014 14.1658 -18.8808 -7342 4 25.6285 12.278 4.29668 -11.0155 5.7348 17.6305 -7343 4 26.0891 10.974 3.64129 -4.70103 -13.8965 4.54114 -7344 6 33.2526 2.15457 18.2061 -11.4346 36.8522 -3.73875 -7345 4 32.7853 2.99777 18.4754 10.6797 -23.9754 -11.6278 -7346 4 32.6748 1.45157 18.4903 -6.58847 -5.37306 4.71859 -7347 6 1.56641 29.1164 15.6218 -13.5802 38.9916 52.9136 -7348 4 0.75332 28.6899 15.9164 -2.28927 1.65734 -1.12046 -7349 4 1.88381 28.6368 14.9104 18.6776 -39.2188 -53.7174 -7350 6 41.7212 4.09992 39.5909 -11.2791 25.9615 -27.213 -7351 4 41.4168 4.81457 38.9155 6.653 -41.6332 33.8875 -7352 4 40.9635 3.53859 39.8438 1.60091 7.46224 -7.31473 -7353 6 28.6931 41.7984 21.1891 -6.68751 -8.42641 -4.80462 -7354 4 29.0735 0.780303 21.3271 9.25035 -16.558 -3.13259 -7355 4 29.3834 41.1221 21.0106 -2.7364 22.7931 4.70591 -7356 6 11.6395 12.4176 35.4525 -19.931 13.6599 -6.89173 -7357 4 11.6974 12.2316 36.3791 0.0383878 -4.43782 22.0781 -7358 4 12.5438 12.3774 35.1867 22.2579 1.64914 -11.6458 -7359 6 9.79005 12.0613 0.287125 39.0331 19.741 15.6941 -7360 4 10.6741 12.3652 0.649112 -24.288 -6.9143 -28.8601 -7361 4 9.37178 11.7496 1.07064 -16.9981 -12.0004 12.0483 -7362 6 48.1738 12.4001 9.21087 -14.7098 16.6281 -3.51107 -7363 4 48.3046 11.757 8.50338 5.36034 -5.93883 0.971929 -7364 4 48.886 12.3441 9.8545 11.7295 -7.72549 2.46367 -7365 6 20.1355 24.3829 18.9522 12.9308 -0.734849 -39.1055 -7366 4 19.4937 23.7815 18.5135 12.9255 8.80461 9.87411 -7367 4 20.8069 24.6162 18.234 -21.1698 -7.06963 26.7537 -7368 6 16.5393 31.2961 16.4761 -1.92172 -19.5246 -12.7122 -7369 4 16.66 32.2288 16.679 -4.64409 4.5232 17.4599 -7370 4 16.1207 30.7474 17.1716 1.36469 17.4989 2.94612 -7371 6 1.78169 14.6393 36.2977 19.9207 14.6923 -9.09136 -7372 4 1.03986 14.2937 35.8105 -15.9251 -7.35249 0.645581 -7373 4 1.68132 14.4688 37.2355 -8.64532 -4.94464 12.0587 -7374 6 4.36624 29.2084 29.5903 15.7403 17.1522 -11.4447 -7375 4 4.94475 28.7816 30.2313 0.42296 -3.8665 4.22363 -7376 4 4.9316 29.8996 29.1557 -19.5902 -17.4666 6.54186 -7377 6 43.6839 0.248111 22.6506 -19.7732 -13.3298 -9.50689 -7378 4 42.8764 0.661685 22.3065 0.028666 2.48852 1.60322 -7379 4 43.5183 41.2016 22.5042 11.2477 10.9397 1.57875 -7380 6 52.4994 40.9828 27.2386 -0.538127 -6.12089 -28.931 -7381 4 52.76 40.8447 26.286 -9.02638 3.90908 21.7421 -7382 4 53.2684 41.4137 27.6303 2.05735 4.02476 1.85103 -7383 6 25.5814 23.8969 27.7396 -24.7861 2.98762 0.531627 -7384 4 24.718 24.3642 27.6072 20.4038 -13.4527 4.15226 -7385 4 26.2821 24.4835 27.457 3.8963 1.45656 -1.88052 -7386 6 23.1228 17.031 33.3243 -5.52517 1.23961 5.4323 -7387 4 23.1399 17.5083 34.1558 0.441881 0.23205 -0.480567 -7388 4 22.8557 16.1383 33.5546 -4.67547 -8.64305 1.56256 -7389 6 2.92722 11.8725 21.3561 -41.4423 -19.1296 -19.7046 -7390 4 2.18606 11.2638 21.6443 29.5918 21.1066 -8.34803 -7391 4 3.54191 11.9259 22.0595 17.1072 -0.484489 21.5157 -7392 6 2.18317 4.15265 30.0257 5.779 -9.3787 -10.7468 -7393 4 2.12921 5.11001 30.0802 -2.76576 12.2821 -0.843831 -7394 4 2.67493 3.96573 29.2018 -3.29095 2.88479 4.98522 -7395 6 26.6728 30.2949 13.4768 7.17255 0.654769 14.1147 -7396 4 25.7117 30.2905 13.6467 8.22624 -2.44269 3.31295 -7397 4 27.1112 30.3188 14.3546 -11.9073 -0.623098 -17.8849 -7398 6 24.8734 30.8117 10.8292 -29.6944 -3.60301 -2.53615 -7399 4 25.2254 30.0431 10.3884 7.40196 -6.71761 -6.36825 -7400 4 25.5983 31.2424 11.2381 22.0508 11.6497 12.6203 -7401 6 53.1723 24.107 4.51212 -8.50651 -29.3458 16.902 -7402 4 53.5087 24.8189 4.00388 11.9327 21.9784 -14.7749 -7403 4 53.9335 23.6869 4.92936 2.49868 2.30602 2.88115 -7404 6 24.9006 4.49574 23.9943 -15.2803 12.8054 -1.91421 -7405 4 24.3197 5.26112 23.9044 -17.3839 -11.7779 6.16284 -7406 4 25.6928 4.95696 23.7819 42.3091 -2.82475 -3.31223 -7407 6 34.6808 1.64534 41.2582 -1.16689 -16.4189 -19.1193 -7408 4 35.6107 1.42238 41.0689 -7.35569 3.11738 8.02352 -7409 4 34.6894 2.06091 0.199506 5.11707 10.3461 19.9542 -7410 6 13.3318 19.5273 16.3875 10.456 -31.2285 9.008 -7411 4 13.8245 19.0713 15.6714 -4.89067 6.02882 4.66139 -7412 4 13.1633 18.7854 17.0362 1.8233 23.0525 -16.1268 -7413 6 48.6827 0.169575 20.4108 24.7259 -31.926 -14.6767 -7414 4 49.2893 41.6148 19.7702 -18.6338 21.3246 17.3218 -7415 4 48.933 41.6689 21.2514 -6.5025 5.85221 0.333279 -7416 6 43.0578 27.7881 11.5189 -10.6888 1.76469 -10.0665 -7417 4 42.6538 28.0077 10.6554 5.1393 -6.0393 10.108 -7418 4 43.5199 28.5835 11.7935 3.33621 0.984046 2.36511 -7419 6 25.7084 21.3766 35.1933 7.92601 18.71 -2.37973 -7420 4 25.8037 22.0957 34.5091 -5.30878 -22.9017 16.0752 -7421 4 25.4462 20.5484 34.7558 3.58761 11.0813 -0.636196 -7422 6 44.7325 4.60288 27.7529 -5.18995 0.47983 -9.95788 -7423 4 44.2388 4.02478 27.1463 1.34738 -4.40857 1.63455 -7424 4 44.3371 5.47709 27.6067 3.7052 -1.13476 4.16529 -7425 6 41.2786 11.441 34.2043 -0.416747 21.9122 -5.07112 -7426 4 40.7165 11.5703 33.4237 0.0697438 -4.14349 0.395824 -7427 4 41.2047 10.5155 34.4107 -4.51201 -19.8544 2.93408 -7428 6 19.8751 36.6454 2.03332 12.5662 31.6724 6.60432 -7429 4 20.6794 36.321 2.43856 -1.22315 -24.7147 -1.51883 -7430 4 20.0441 37.6041 2.15193 -20.0718 -8.75186 -9.57731 -7431 6 27.484 4.65653 6.35518 1.28922 -40.4385 -58.6648 -7432 4 27.5497 3.77116 6.72735 -1.75384 3.56143 11.9553 -7433 4 27.4257 5.33486 6.97498 -2.79123 31.4549 44.9969 -7434 6 16.8428 30.7659 39.9509 7.31092 -42.6244 -5.47757 -7435 4 16.9464 31.3097 40.7337 2.60533 1.47109 13.0941 -7436 4 17.1496 29.8303 40.1512 -5.48449 28.5555 1.20442 -7437 6 51.1542 15.2049 16.3406 35.1838 19.4064 -24.6303 -7438 4 51.2473 16.0791 15.87 -9.06363 -20.4986 13.944 -7439 4 52.0128 14.747 16.0894 -33.4595 8.32861 13.6861 -7440 6 49.9911 21.2271 35.9695 16.4294 -24.4585 13.2328 -7441 4 49.3547 21.5056 35.3276 -17.8928 6.13619 -17.6667 -7442 4 49.9245 20.2453 36.0087 2.29216 20.3869 -1.95357 -7443 6 34.4275 0.15221 5.68266 -0.837995 23.3079 0.855413 -7444 4 34.2957 0.929489 6.27037 2.93096 -11.6463 -16.4536 -7445 4 34.3488 0.459476 4.74482 0.623699 -7.30698 18.2278 -7446 6 48.316 11.5365 19.8846 -3.65813 -3.14803 11.8504 -7447 4 47.8503 11.3247 20.7373 6.31016 14.4835 -28.1035 -7448 4 47.7834 12.1052 19.2757 1.33379 -13.4076 20.6299 -7449 6 4.19577 39.4409 13.3607 25.3524 9.34899 10.5928 -7450 4 4.92582 39.74 13.9847 -33.0668 -7.48624 -17.3574 -7451 4 3.31127 39.5736 13.758 11.9971 1.78205 4.76714 -7452 6 8.7457 16.1809 8.53298 -1.62633 17.1572 -22.0575 -7453 4 8.74512 16.8853 9.19115 0.0519099 -7.3494 1.25428 -7454 4 8.72812 16.6658 7.66651 -0.023414 -16.7756 16.7144 -7455 6 29.0271 14.2712 26.5342 -13.8591 45.9397 20.1216 -7456 4 29.0757 15.2697 26.7309 6.93185 -43.1811 -12.6551 -7457 4 28.1042 14.0702 26.7795 9.9397 -3.04712 -3.53591 -7458 6 27.3813 14.5204 8.1419 -14.0666 1.8718 0.247246 -7459 4 26.4091 14.3966 8.10069 17.9482 5.30051 2.04476 -7460 4 27.5539 15.4689 8.31094 -4.76419 -14.5771 -1.3831 -7461 6 14.1301 27.2156 32.9232 24.3629 15.6041 -10.7258 -7462 4 14.926 27.3266 33.4685 -8.09546 -2.45296 -2.52419 -7463 4 13.4702 26.8045 33.4616 -14.5983 -10.6772 12.2116 -7464 6 31.6563 35.7792 21.2709 -29.1401 -25.1051 5.88501 -7465 4 32.0219 36.5153 21.7512 6.27263 14.1007 6.62418 -7466 4 30.8825 35.462 21.8184 22.9209 7.6802 -13.887 -7467 6 54.2186 28.7134 16.8958 -10.3287 11.0002 2.01575 -7468 4 53.5002 28.4234 16.309 3.24852 -2.61584 3.16662 -7469 4 53.9524 29.6107 17.1726 0.515277 -7.78004 -0.375364 -7470 6 9.0512 5.27483 17.1492 25.6572 1.38615 -17.9054 -7471 4 9.89534 5.12229 16.6101 -31.8522 3.085 22.1798 -7472 4 8.85255 6.23494 17.0921 1.81156 -15.0607 2.57474 -7473 6 29.6868 9.77258 26.5671 22.9889 -14.8503 10.4327 -7474 4 30.5444 9.2887 26.5838 -17.3341 11.3615 1.53321 -7475 4 29.3655 9.78642 27.4819 2.88877 -1.07091 -0.346791 -7476 6 44.0288 31.1766 32.1743 -14.2068 1.02328 22.4178 -7477 4 43.2475 30.9789 32.739 9.50682 -2.17476 -16.522 -7478 4 44.5788 31.7142 32.7564 8.88854 3.82935 -1.95952 -7479 6 53.49 3.62433 25.1454 11.2777 4.02107 -26.8953 -7480 4 54.1404 4.33507 25.1993 -2.49783 6.11479 15.045 -7481 4 53.6886 3.29227 24.2489 -10.294 -6.80459 12.4065 -7482 6 12.451 22.8746 3.38821 10.4278 8.96452 22.9237 -7483 4 12.7779 22.025 3.15024 17.1772 -24.972 1.67394 -7484 4 11.7815 22.9738 2.74712 -31.3784 16.165 -21.5343 -7485 6 39.42 29.6871 0.722943 17.2287 20.3893 -0.939439 -7486 4 39.938 29.1007 0.168548 -5.00448 -5.71086 -1.61555 -7487 4 38.6697 29.2119 1.03517 -14.5725 -11.7208 3.22357 -7488 6 13.7451 37.8179 23.0399 -3.65878 -32.3471 -6.65898 -7489 4 14.6418 38.0465 23.3627 -20.7195 15.519 -6.09735 -7490 4 13.1315 38.5597 22.9108 15.1185 11.2609 5.5967 -7491 6 33.3417 41.2334 -0.000336223 20.2285 27.8942 26.4667 -7492 4 33.8463 0.176253 41.7571 -17.5829 -26.3423 -4.93882 -7493 4 33.4991 41.0748 0.960438 -12.6248 -4.93214 -20.7453 -7494 6 15.7246 3.51737 6.33987 10.6879 -4.05507 31.4744 -7495 4 14.9251 3.29652 6.83809 -1.96505 1.65417 1.3128 -7496 4 15.4345 3.71468 5.4634 -8.944 6.24557 -22.4591 -7497 6 27.7713 30.7539 5.06912 -9.69485 -19.9648 -11.4393 -7498 4 28.5319 30.6575 5.66481 -7.77203 -4.90526 -3.90413 -7499 4 27.6074 29.8515 4.67882 9.36195 16.9347 11.4385 -7500 6 13.3277 7.57287 23.3467 18.1651 -5.37845 17.9429 -7501 4 14.1986 7.86136 23.0073 -11.0143 -2.49266 1.50668 -7502 4 12.7134 7.55433 22.6278 -8.93981 2.52131 -14.7715 -7503 6 38.3049 37.3174 27.9983 8.70135 -12.5747 15.655 -7504 4 38.3154 37.3922 27.0572 -6.74668 8.75695 -30.2201 -7505 4 39.0324 36.7087 28.1704 1.61648 -2.88985 11.5174 -7506 6 35.8266 12.5392 12.0897 -2.57405 -7.53067 12.8361 -7507 4 35.6491 11.5922 12.0112 2.97069 1.46586 -4.70523 -7508 4 36.2655 12.8127 11.2954 6.10525 2.83369 -11.8718 -7509 6 52.1153 23.0889 41.2774 53.3714 4.98692 -14.9993 -7510 4 52.5505 23.0114 40.3503 -31.9828 -2.74691 35.5054 -7511 4 51.1752 22.9201 41.2974 -16.3051 -5.99839 -13.4785 -7512 6 39.5458 11.6586 16.6081 -4.87816 2.10267 -34.9091 -7513 4 39.8889 10.7596 16.6462 4.61035 -3.54577 11.4771 -7514 4 39.4661 12.017 17.4857 2.58954 -3.33375 20.5696 -7515 6 0.680688 9.01153 7.97148 24.3969 36.1639 -33.0882 -7516 4 54.7452 9.01592 8.14854 -24.8099 -10.5681 8.91807 -7517 4 1.15172 8.32837 8.40327 2.66278 -26.2854 21.5078 -7518 6 42.3319 28.747 39.482 14.4944 54.9029 13.7373 -7519 4 41.6099 28.5069 40.0315 -24.977 -16.9351 14.372 -7520 4 42.5658 28.0062 38.9777 10.1954 -37.5926 -27.6332 -7521 6 38.7351 30.2774 16.2793 4.0737 2.19128 11.2593 -7522 4 38.8758 29.8829 17.1681 -0.562728 7.98522 -10.8415 -7523 4 39.3736 31.0181 16.2214 -9.64538 -12.7452 3.65311 -7524 6 7.59373 18.0328 0.655349 -39.2466 -13.429 1.02247 -7525 4 7.12412 17.545 1.38102 15.2508 10.2608 -15.5396 -7526 4 8.49503 18.0746 0.920891 28.7098 -1.69475 13.4339 -7527 6 33.7283 34.5883 24.1367 2.81913 -0.677006 -1.55035 -7528 4 33.5209 35.3543 23.5868 -0.36085 -2.23271 3.31185 -7529 4 34.0202 34.925 24.9956 3.1898 -0.550642 -1.12415 -7530 6 16.0108 40.0553 39.5926 -11.937 1.54577 -14.812 -7531 4 16.9471 40.1686 39.433 15.7688 -0.191962 4.71606 -7532 4 15.632 40.0274 38.6953 -1.55756 -1.47356 6.94311 -7533 6 4.49381 37.1265 21.8421 33.1234 -31.7004 -39.5319 -7534 4 4.78916 37.7556 22.4729 8.60512 21.3704 21.7375 -7535 4 5.32421 36.8863 21.3047 -36.9575 7.65083 16.8008 -7536 6 39.2568 20.1405 31.3294 -11.3601 -2.01094 -17.3558 -7537 4 39.2441 20.8952 31.9186 1.64276 10.2876 11.6417 -7538 4 38.6708 20.3662 30.5789 5.24327 3.39586 9.04201 -7539 6 28.5615 6.15748 32.0463 -1.77815 -13.6106 -5.56393 -7540 4 29.3688 6.39317 32.5024 4.03477 3.32162 5.90581 -7541 4 28.0645 6.97719 31.936 3.86184 3.53187 3.02469 -7542 6 9.32925 11.326 38.2021 -45.7357 8.82179 -18.9514 -7543 4 8.63026 12.0506 38.2047 26.1946 -20.5574 6.08922 -7544 4 8.95275 10.6938 37.5333 17.8336 11.1262 12.3014 -7545 6 41.6094 10.4714 6.86105 10.1449 -2.02989 30.4141 -7546 4 41.8033 10.1647 7.80154 -6.16714 11.7455 -31.3638 -7547 4 41.7667 11.4361 6.82819 -2.03628 -11.6206 -3.02795 -7548 6 3.11959 28.1093 17.6239 10.7497 -46.175 24.4008 -7549 4 2.68352 28.5892 16.9552 -19.7085 26.1099 -29.6067 -7550 4 3.57016 28.7359 18.1797 1.91623 14.188 4.79643 -7551 6 39.3448 12.237 19.2548 -14.1137 14.4353 18.1644 -7552 4 39.3198 13.2124 19.4672 -0.23776 -25.4214 -5.72266 -7553 4 38.5957 11.8144 19.7397 13.7352 7.639 -10.0067 -7554 6 2.76578 9.12322 31.711 10.2249 -26.7767 20.5709 -7555 4 3.2959 8.42892 32.18 -23.1647 11.967 -1.06293 -7556 4 3.41205 9.47362 31.1162 6.35119 16.2437 -14.7539 -7557 6 47.0978 34.3186 24.1743 26.4285 -20.6373 22.1669 -7558 4 47.9222 34.8155 23.9694 -26.3889 2.76484 -4.38573 -7559 4 46.3048 34.7125 23.8251 -6.69439 19.4391 -11.1209 -7560 6 41.2781 35.6191 9.5379 -9.82526 -0.200667 -5.59214 -7561 4 40.3156 35.6289 9.77314 20.3165 9.2235 -0.933793 -7562 4 41.677 36.5159 9.62264 -17.3348 -12.0484 0.717846 -7563 6 20.4662 31.4486 3.15039 -21.7086 3.64016 -5.07598 -7564 4 21.0332 31.2208 3.90109 -5.23001 0.711793 3.99895 -7565 4 19.5233 31.6154 3.43158 26.7394 -6.53789 -0.258783 -7566 6 33.2215 17.9623 24.8097 -0.453891 -1.34226 7.30289 -7567 4 34.1788 17.9667 25.0617 -18.0356 9.24084 -3.8919 -7568 4 32.8105 18.8566 24.8334 12.2893 -13.6267 3.75162 -7569 6 40.152 39.887 35.7648 -20.6867 7.32712 26.7748 -7570 4 39.5869 39.7633 34.9934 2.3303 1.35559 2.0998 -7571 4 39.5428 40.1203 36.5292 18.9615 -7.74514 -25.9591 -7572 6 4.86846 34.7127 16.4904 2.99496 1.45153 -7.51648 -7573 4 4.94748 35.6438 16.2302 0.473437 -5.16658 -0.520329 -7574 4 5.67201 34.2663 16.1683 2.12015 0.152524 1.06444 -7575 6 19.1332 11.0374 26.5471 0.604362 14.7011 2.3555 -7576 4 19.0986 10.7741 25.6217 -2.73437 -5.06461 -1.05922 -7577 4 19.4813 10.3027 27.0576 -1.53582 -10.5153 -0.687646 -7578 6 54.0201 13.9196 34.7874 -7.69802 -2.07317 -2.05829 -7579 4 53.0764 13.9769 34.9536 -3.33021 -5.1824 4.14914 -7580 4 54.0417 14.262 33.8952 13.8623 5.56658 -9.2157 -7581 6 1.84699 20.6587 5.20972 14.9439 0.361847 -39.2318 -7582 4 1.3018 19.9191 4.88605 -0.816153 4.45331 11.6833 -7583 4 2.38828 20.8916 4.39492 -13.6739 -1.13034 29.3331 -7584 6 22.2428 0.0912174 14.2544 2.10511 -1.36215 24.2926 -7585 4 21.4939 0.626329 14.4934 -11.4394 6.88953 -7.77601 -7586 4 22.6568 41.86 15.1175 2.53583 -3.69112 -10.285 -7587 6 4.95629 7.04242 24.7427 6.31781 -9.23371 -7.19194 -7588 4 4.17782 7.32111 24.2434 0.969413 4.1364 5.47863 -7589 4 5.24611 6.21648 24.3187 1.32276 5.05146 9.71893 -7590 6 41.4805 20.8726 34.9438 -11.2314 22.7349 11.4525 -7591 4 42.1022 20.1554 34.9949 12.4759 -11.6791 0.0999164 -7592 4 41.5325 21.3468 35.8092 3.20944 -13.6901 -15.0483 -7593 6 28.2157 1.74547 31.725 -9.95228 -2.94536 5.02618 -7594 4 27.5723 1.08944 32.0352 4.54694 0.234407 -12.282 -7595 4 28.3302 2.26918 32.5198 6.68924 9.49254 2.75715 -7596 6 16.8899 27.3746 36.9858 -9.49677 -4.03922 3.2671 -7597 4 17.2157 28.1459 36.4964 2.86939 -7.49192 -2.31982 -7598 4 17.0938 26.5386 36.5152 1.89463 15.2676 -1.69393 -7599 6 26.8243 38.069 8.34482 13.7761 41.6132 3.1747 -7600 4 26.4823 38.3279 9.22598 3.84792 -18.6223 -11.4711 -7601 4 26.785 37.1424 8.19579 -7.88027 -37.9853 9.71444 -7602 6 26.6634 33.7911 23.2273 -21.2745 -8.43567 7.74896 -7603 4 27.1019 33.3181 22.5212 7.04537 -0.372104 -6.32159 -7604 4 27.3305 34.169 23.7872 14.5385 6.50935 5.10733 -7605 6 10.2166 27.1183 30.2276 16.2509 -17.1331 -9.46175 -7606 4 10.1765 28.0583 30.3796 2.29392 15.9864 2.71565 -7607 4 10.9387 26.9511 29.5696 -14.5483 8.58048 15.0042 -7608 6 47.87 12.5975 5.02268 -6.13754 10.9902 -1.31963 -7609 4 48.1357 13.4822 5.34438 -4.36861 -17.8106 0.719643 -7610 4 48.2725 11.9144 5.56853 6.38614 1.6905 7.47062 -7611 6 53.3393 24.5639 22.1523 -40.2275 -1.43509 1.91788 -7612 4 53.1884 24.513 23.11 6.12251 -0.709171 0.80005 -7613 4 54.2538 24.6676 21.944 28.1496 2.10984 1.66559 -7614 6 29.4072 10.7569 19.3822 52.4151 15.8336 -9.71081 -7615 4 29.248 9.98119 18.8618 -10.0643 -15.3346 -6.0739 -7616 4 28.6282 10.9567 19.8417 -45.3483 4.87471 22.9978 -7617 6 39.4757 14.9522 19.5461 30.0359 -1.30311 42.0602 -7618 4 40.386 15.231 19.9108 -38.5728 -7.77311 -23.4682 -7619 4 39.3498 15.357 18.6983 1.75067 15.7407 -16.9704 -7620 6 32.8823 15.9838 22.806 -0.988113 9.61369 -4.64335 -7621 4 32.9657 16.5376 23.5815 3.43203 16.8704 5.79609 -7622 4 32.7087 15.1359 23.1895 -5.55033 -22.0541 3.57771 -7623 6 30.5481 1.96835 21.5144 8.4955 -1.31523 7.25762 -7624 4 30.7645 2.06729 22.4547 -1.5525 1.72807 -3.05596 -7625 4 31.3563 1.607 21.1075 -12.3766 3.94884 0.453046 -7626 6 0.972615 11.9937 3.31932 2.75381 16.0475 9.69945 -7627 4 1.12058 12.9582 3.29011 -6.67466 -9.20629 -8.78254 -7628 4 1.16803 11.7633 4.23669 1.49118 -7.35844 2.879 -7629 6 32.1487 30.4035 20.7885 -10.2937 2.79415 -8.64413 -7630 4 32.9584 30.6778 20.3377 1.19491 2.22071 -1.75985 -7631 4 31.4018 30.7106 20.2304 12.8433 -5.61998 7.3235 -7632 6 5.36663 35.5196 9.0005 -13.7636 -10.8617 -1.51226 -7633 4 5.10558 35.6694 8.09522 3.88385 7.21083 -8.97177 -7634 4 4.84313 34.7327 9.21079 3.19207 0.561776 9.20467 -7635 6 49.9075 13.051 32.2032 24.7068 -1.78611 -22.7634 -7636 4 50.5917 12.8604 31.4934 -20.1594 10.2365 23.451 -7637 4 49.3072 12.3042 32.1357 -5.12737 -3.80929 6.93874 -7638 6 4.31321 24.0956 1.58545 -15.4175 -15.0012 -21.2972 -7639 4 3.62325 24.7374 1.73273 -2.73087 12.0747 8.21305 -7640 4 3.96758 23.5799 0.823479 15.3265 9.07188 13.8923 -7641 6 44.1581 38.1227 12.3545 -1.42535 -29.4608 0.820402 -7642 4 43.4877 37.5183 12.7749 7.78878 22.0847 -6.23147 -7643 4 43.9706 39.05 12.5061 -8.83193 8.8938 6.46859 -7644 6 44.688 17.3349 22.7943 52.857 -4.21013 7.29678 -7645 4 45.2391 18.0521 23.242 -20.6522 -19.8992 -14.1432 -7646 4 45.3699 16.6167 22.57 -26.4285 25.231 9.0384 -7647 6 20.3608 11.6914 19.667 7.58964 -15.1508 -20.1027 -7648 4 20.0231 12.466 20.0832 -9.22037 21.7722 17.9466 -7649 4 20.541 12.011 18.7627 0.78957 -9.8802 4.31695 -7650 6 4.45783 15.4051 36.2022 4.17523 -10.6616 -1.13379 -7651 4 5.07913 14.7124 35.8925 -4.22209 9.46347 0.0108161 -7652 4 3.57023 15.0045 36.1544 3.18966 5.51307 1.04981 -7653 6 44.8105 39.5245 30.1712 -12.2097 -12.5983 -29.4865 -7654 4 44.6649 39.2374 29.2388 12.2423 8.81859 19.2473 -7655 4 44.0848 39.0946 30.6384 -0.298867 5.38951 7.86823 -7656 6 30.0635 3.50956 11.3278 16.0802 -2.39158 -40.3094 -7657 4 30.5444 4.30508 11.007 -11.8296 -5.04519 20.5985 -7658 4 30.1379 2.92562 10.5291 -8.6007 1.99314 24.6663 -7659 6 25.6288 24.8657 16.1423 35.3146 -5.68436 -0.158812 -7660 4 26.5897 24.7732 15.9989 -9.69879 -4.30362 -13.2764 -7661 4 25.6615 25.1054 17.0605 -14.6317 7.6504 23.2411 -7662 6 36.8074 29.8609 20.6529 -16.3286 -4.81766 17.6852 -7663 4 35.9316 30.2459 20.3982 14.0867 -8.19012 9.60149 -7664 4 36.7164 29.3161 21.4988 -1.56746 21.2483 -31.978 -7665 6 52.2273 17.0565 38.3075 -18.6216 -30.1938 15.1193 -7666 4 51.4912 16.4635 38.6201 23.7372 14.7716 -7.00173 -7667 4 51.7959 17.5937 37.6524 -0.777677 7.661 -6.77585 -7668 6 3.82637 23.6296 29.8591 26.0466 24.015 14.1033 -7669 4 4.67122 23.3872 29.4436 -4.98409 -4.75234 -2.50433 -7670 4 4.14214 24.3103 30.5173 -20.0237 -17.5461 -14.7603 -7671 6 6.36694 19.9104 41.0994 -7.87156 6.69529 -0.551213 -7672 4 6.75531 19.2216 41.6418 3.91706 -4.8357 7.00798 -7673 4 6.43687 20.7189 41.61 0.371167 5.3541 9.12827 -7674 6 28.9069 38.9219 35.3342 18.1363 5.4885 19.4373 -7675 4 28.4975 38.2544 34.8057 -13.0204 -17.6003 -18.1497 -7676 4 29.7244 38.4883 35.6529 -6.84193 6.3312 -4.3373 -7677 6 1.06391 30.294 34.4744 17.4659 -4.25802 33.126 -7678 4 0.923806 29.8092 33.6831 -4.92213 -16.9626 -31.6436 -7679 4 0.43107 31.0027 34.4841 -13.3738 11.5818 -2.38269 -7680 6 26.4433 22.0338 20.438 10.4135 -19.5508 3.73058 -7681 4 27.3849 22.2767 20.3653 -17.5193 8.20183 -1.91668 -7682 4 25.8117 22.75 20.2981 5.30742 7.62512 -2.77887 -7683 6 3.9439 18.647 22.686 19.6053 -30.212 14.064 -7684 4 4.76982 18.631 23.2404 -22.0254 9.00566 -12.7221 -7685 4 3.71052 19.5535 22.5456 -1.30938 28.7031 -1.82281 -7686 6 6.87955 39.3273 26.9921 -1.67667 -12.9446 -11.9216 -7687 4 7.1836 39.9129 27.6984 -12.429 3.42242 7.34442 -7688 4 5.90054 39.2886 26.9896 13.9064 15.8094 12.8698 -7689 6 43.976 41.7556 26.5281 4.8347 -4.89589 -5.39334 -7690 4 43.9038 0.242071 27.3891 4.48323 5.1383 20.2804 -7691 4 43.1144 41.9148 26.1591 -17.5097 2.26447 -13.804 -7692 6 31.7137 29.57 16.9845 -29.8695 1.84649 5.70955 -7693 4 31.0051 28.8814 16.8861 15.511 13.0746 -1.88966 -7694 4 31.2475 30.3377 17.3963 12.872 -19.7765 -2.8161 -7695 6 46.2467 10.9544 15.5549 14.6537 -15.0388 13.4913 -7696 4 45.2992 10.7621 15.4719 2.35584 -6.3837 2.44855 -7697 4 46.7422 10.1008 15.6673 -18.7057 18.8904 -8.1417 -7698 6 36.5806 15.025 25.8165 21.8026 1.76557 9.13915 -7699 4 37.3648 15.4873 26.2149 -21.7037 -15.0217 -10.3096 -7700 4 36.1201 14.6319 26.5704 -2.31195 -1.95921 2.19148 -7701 6 47.2758 22.6707 6.12549 -20.393 21.5378 -17.5673 -7702 4 46.5536 23.2672 5.80637 16.9751 -15.6011 5.88158 -7703 4 47.0174 22.4855 7.02503 2.56882 -3.04752 8.65489 -7704 6 27.5281 39.6653 17.8063 9.11062 13.5998 -14.667 -7705 4 26.6008 39.6971 17.5421 -9.18871 -3.65478 0.40423 -7706 4 27.5952 39.1072 18.5692 -4.91094 -8.97362 13.813 -7707 6 14.0432 27.9674 36.8911 6.42031 -13.692 3.20322 -7708 4 13.4093 27.2386 36.6831 22.3711 16.0651 -1.21324 -7709 4 14.9745 27.6178 36.9209 -23.5128 3.35359 -2.56993 -7710 6 33.7582 13.0225 13.8549 2.82411 10.3644 -10.1378 -7711 4 34.6192 13.1187 13.3682 -26.1927 -14.0119 11.7219 -7712 4 33.447 12.1034 13.9061 16.5995 3.21583 -3.74575 -7713 6 3.39066 17.4794 1.96807 -11.027 -24.2448 -29.9928 -7714 4 3.01559 16.7425 1.36999 17.4474 35.7284 24.3857 -7715 4 3.43148 18.2603 1.39088 -0.910914 -5.0095 5.82543 -7716 6 27.5636 2.76805 36.4448 23.3016 6.40537 7.49337 -7717 4 28.0874 2.94382 35.6362 -14.0128 -4.70143 5.95918 -7718 4 26.7201 2.39292 36.1778 -1.1877 -0.145823 -5.22631 -7719 6 21.3174 1.20043 18.721 3.60184 -34.5623 26.1973 -7720 4 20.9731 2.06802 18.64 -8.90193 33.3239 -10.7294 -7721 4 20.989 0.903829 19.6038 6.52339 -1.5964 -17.0558 -7722 6 11.8953 16.678 29.2972 -24.0209 -12.1876 15.7906 -7723 4 10.9907 16.5502 28.9196 20.2967 4.53139 4.03679 -7724 4 11.83 16.2797 30.2084 5.50538 14.3948 -24.2902 -7725 6 15.9723 29.4609 29.6333 0.682268 26.1612 18.9471 -7726 4 16.8848 29.3174 29.3467 -1.47573 8.2327 2.84191 -7727 4 15.9822 30.2485 30.2615 3.64459 -27.0302 -18.4378 -7728 6 42.9269 7.03734 4.5197 11.663 -6.03152 6.53833 -7729 4 43.4231 7.50219 3.8104 -1.91258 -11.2042 14.7177 -7730 4 43.564 6.5391 5.10838 -14.9069 13.4822 -19.2581 -7731 6 46.4099 26.3175 18.5001 -14.65 2.77244 -10.2078 -7732 4 46.6739 27.1133 19.0164 -10.4759 -17.1195 -12.5948 -7733 4 45.7242 26.5969 17.8403 16.3643 -1.95791 15.5671 -7734 6 26.8576 31.9381 30.1176 11.4414 -26.9795 -35.8502 -7735 4 27.1259 30.9869 29.8859 -9.79711 36.6724 15.314 -7736 4 26.5998 32.3006 29.2227 5.46388 -10.7605 29.9307 -7737 6 19.4818 37.6192 31.2596 -32.5143 -22.3469 33.0613 -7738 4 19.0962 36.8501 30.8088 8.72557 8.52431 -5.84089 -7739 4 19.0944 37.5229 32.1795 16.9146 13.3756 -22.466 -7740 6 52.3665 32.7318 12.7942 -5.34222 7.33615 -3.08781 -7741 4 51.884 32.8768 11.9489 17.9119 0.95058 7.1847 -7742 4 53.27 33.1068 12.8183 -18.0778 -3.45769 -11.3622 -7743 6 6.73992 9.26339 24.0285 -18.4022 -33.2824 -0.456279 -7744 4 6.43016 9.52976 23.1488 2.39009 0.543925 -1.37305 -7745 4 6.14044 8.50785 24.2751 15.0572 15.2043 -3.93749 -7746 6 39.7373 39.5658 25.499 -11.0807 -5.52867 0.517577 -7747 4 39.7453 38.628 25.2585 2.77876 5.57729 -0.31401 -7748 4 38.826 39.699 25.8216 4.65786 0.889055 -1.26295 -7749 6 24.0734 14.0105 21.1438 13.9648 5.3121 -25.5312 -7750 4 23.6065 13.6215 21.8839 -3.42696 -11.6299 6.48748 -7751 4 24.3304 13.3134 20.491 -9.48085 14.6929 20.6508 -7752 6 5.1987 41.7736 24.8713 10.0047 -19.0707 10.1325 -7753 4 6.05769 0.0475547 25.2635 0.547146 -1.74599 -5.91735 -7754 4 4.86042 0.69526 24.5593 -4.41349 12.4443 -5.8689 -7755 6 42.3687 20.86 21.2777 19.2234 -22.1312 -1.40502 -7756 4 42.3783 20.5581 22.1846 0.624409 -1.73106 8.2154 -7757 4 41.7113 21.532 21.2665 -20.5735 20.428 -5.9858 -7758 6 48.2425 15.3687 33.5924 -0.241089 -2.38933 -5.28694 -7759 4 48.6415 14.7162 33.0072 6.18243 -4.87195 3.86709 -7760 4 47.6596 15.8553 33.0028 -7.11438 7.34599 -0.780278 -7761 6 46.0202 38.2953 16.5865 15.7829 17.4793 7.01852 -7762 4 46.7193 37.7552 17.0318 -13.8218 15.7663 -8.05182 -7763 4 46.1673 39.253 16.8241 -2.73609 -24.364 -6.22008 -7764 6 4.62701 28.4898 21.3631 -35.4199 -38.8764 -1.71187 -7765 4 5.05003 28.7578 22.1614 14.3175 13.903 20.3467 -7766 4 4.23296 27.6059 21.6238 11.0236 23.568 -16.8729 -7767 6 20.5692 15.1618 18.3974 -2.72234 -3.16682 18.7699 -7768 4 20.0205 15.9086 18.1633 -0.374776 9.93651 -8.10169 -7769 4 20.1114 14.8073 19.1799 7.71486 -3.14336 -3.02048 -7770 6 16.2446 13.6415 17.4737 -35.4034 4.06645 -23.9936 -7771 4 16.1835 14.6144 17.5029 6.20848 -12.1 -0.082548 -7772 4 15.5556 13.4035 16.7727 24.4056 2.85778 27.0666 -7773 6 52.5084 30.9566 18.1567 -0.97573 -12.5044 17.346 -7774 4 52.0533 31.4717 17.4985 -6.50351 10.4198 -16.9401 -7775 4 51.7821 30.6074 18.6971 11.4062 2.54252 -4.46582 -7776 6 24.418 1.73203 15.7939 2.07222 -10.1482 7.47229 -7777 4 24.2447 1.14878 16.5739 0.390494 16.7143 -9.44633 -7778 4 24.1366 2.64887 15.952 -0.929678 -6.23215 5.34629 -7779 6 23.8719 5.08832 31.0744 22.7283 -21.9769 -16.2257 -7780 4 23.8146 5.92648 31.5054 -7.3092 22.9653 9.22328 -7781 4 24.8319 4.92382 30.9303 -16.6577 0.531409 1.66203 -7782 6 29.6615 30.9343 0.410524 16.5859 -5.2272 -6.83283 -7783 4 30.4171 30.5602 -0.0763344 -8.98044 0.909776 12.9407 -7784 4 29.1293 31.2514 41.5907 -13.3941 8.54792 -1.14443 -7785 6 32.8591 37.9003 22.5268 -10.9299 -3.56267 -2.34485 -7786 4 33.7082 38.1164 22.1304 5.81458 1.66065 7.83892 -7787 4 32.835 38.1832 23.4516 6.53001 6.08896 0.386172 -7788 6 16.4762 17.3653 33.758 -11.7596 5.685 -6.41316 -7789 4 15.9639 18.0545 33.2621 15.6067 -10.6469 10.7903 -7790 4 17.1589 17.009 33.1621 -6.01342 7.59956 -1.04496 -7791 6 9.22918 13.3839 27.5418 -13.213 -9.30661 16.5651 -7792 4 8.30942 13.5198 27.2923 -4.71042 4.84624 -13.6557 -7793 4 9.0972 13.1179 28.4658 14.0632 -0.809421 3.61995 -7794 6 43.4685 7.73978 17.2176 -8.6426 5.21856 8.44668 -7795 4 43.4054 7.77113 18.1985 3.14312 -1.73226 -22.4674 -7796 4 44.4071 7.82788 17.0033 -0.931382 -0.0897333 1.197 -7797 6 22.3132 24.3412 23.1703 -9.75348 13.1727 -0.0757149 -7798 4 22.7871 23.5122 23.2675 1.8966 -9.89464 -1.11237 -7799 4 21.5045 24.1854 22.6454 4.5924 -1.52242 4.18414 -7800 6 26.0037 32.9236 32.716 -4.33416 -0.788049 -7.61174 -7801 4 26.2455 32.6516 31.8136 -0.0498336 0.850388 -0.133699 -7802 4 25.1949 32.4304 32.9126 -0.360701 -0.787143 2.76329 -7803 6 16.9426 19.041 7.45715 -3.10994 24.472 -2.41526 -7804 4 16.308 19.3093 8.14456 3.13816 -6.91205 -2.30089 -7805 4 17.0114 19.8381 6.87129 1.57938 -24.3813 10.2947 -7806 6 48.1131 14.4569 27.5699 7.08917 8.35207 6.49885 -7807 4 48.0603 15.1245 26.8691 -1.5138 -4.18476 1.16992 -7808 4 48.1537 14.9494 28.4126 -1.96213 -3.76556 -9.73571 -7809 6 52.3834 41.7541 11.1123 -0.447482 12.3 22.2377 -7810 4 52.3153 0.228199 10.2442 -0.817032 7.00513 -16.5207 -7811 4 52.6623 0.571857 11.7011 -4.41087 -5.87968 -8.23494 -7812 6 36.3325 6.93202 12.7048 -8.66608 5.7588 -1.53482 -7813 4 36.3873 7.88419 12.9074 5.41886 -9.49824 0.0534512 -7814 4 37.2464 6.6206 12.6662 3.93968 -0.5832 -0.272047 -7815 6 8.24609 20.3242 16.6676 2.28714 -8.73249 -3.11806 -7816 4 7.99607 19.3797 16.5602 0.915774 9.85224 4.30221 -7817 4 9.21956 20.3717 16.6442 -3.81833 -2.78155 -1.09608 -7818 6 28.8059 40.3215 12.8316 -6.32157 -2.99739 9.80695 -7819 4 29.5356 40.2333 12.2314 15.0973 -2.52646 -11.1155 -7820 4 28.4555 39.4209 12.8947 -4.4969 5.39171 3.74805 -7821 6 18.1648 11.8204 16.9538 6.42365 10.4423 10.6103 -7822 4 17.6537 12.6149 17.1793 -7.21931 -10.1359 -1.31065 -7823 4 19.063 12.1656 16.925 9.05203 -3.86377 -1.18548 -7824 6 30.8803 17.4233 21.4874 -38.9186 -21.5127 -11.6054 -7825 4 30.1793 16.7188 21.4067 15.4039 25.3522 4.50617 -7826 4 31.5864 16.9116 21.8642 20.5617 -1.86838 10.7411 -7827 6 34.8073 19.4112 37.959 10.4013 19.2527 -16.7989 -7828 4 34.9062 20.1671 37.3279 -0.177011 -16.5385 16.965 -7829 4 34.2544 18.768 37.5084 -3.31564 -7.45818 -3.12702 -7830 6 35.8251 16.8879 29.2053 19.9429 8.12055 25.1888 -7831 4 36.604 16.4922 29.6427 -6.21008 5.15879 -2.88988 -7832 4 35.5164 16.1914 28.6524 -12.7517 -21.289 -18.0185 -7833 6 3.03682 32.2806 6.33235 -9.22618 28.6071 10.2197 -7834 4 2.10307 32.1357 6.11945 6.4331 -12.4482 -1.5948 -7835 4 3.56193 31.5065 6.1559 2.8275 -21.5224 -7.32445 -7836 6 26.8 41.6522 10.1614 16.4152 -10.6242 6.62789 -7837 4 27.6763 41.4103 9.75871 -19.2491 6.11251 13.5217 -7838 4 26.9685 0.0827479 11.0562 4.26354 0.263175 -7.76775 -7839 6 52.2755 24.564 24.8743 -17.4742 4.09161 11.4913 -7840 4 51.3068 24.6875 24.9545 12.6777 -6.48001 -7.54331 -7841 4 52.5704 24.9086 25.7267 7.88636 1.59704 3.61539 -7842 6 22.6859 22.6471 33.5865 3.00815 -0.389016 -3.70522 -7843 4 23.2377 23.2516 34.129 -18.2936 -9.34398 -1.8364 -7844 4 21.8798 22.3666 34.0572 9.18357 8.33181 5.74035 -7845 6 10.6559 14.2334 33.0439 8.40108 -6.88321 -2.71679 -7846 4 10.5166 14.9368 32.4181 8.42324 10.9453 -12.1325 -7847 4 9.76709 14.0756 33.3137 -17.8131 -11.8211 11.2552 -7848 6 21.913 10.8504 11.5417 10.0273 5.1408 -10.1307 -7849 4 22.8643 10.6911 11.6864 -4.5907 0.219491 7.97275 -7850 4 21.4519 10.7503 12.3817 3.5408 -3.26695 13.1151 -7851 6 38.3604 6.02409 25.8423 -7.72295 28.2176 13.9057 -7852 4 38.0159 6.28095 26.7202 2.23326 -16.155 -4.56644 -7853 4 38.4362 6.90267 25.4438 5.48615 -7.56939 -11.5178 -7854 6 30.9465 26.6393 38.5732 9.04128 -30.5088 -25.1958 -7855 4 30.9128 26.4505 39.498 -1.67119 3.99535 28.8865 -7856 4 31.0441 25.726 38.2186 -4.36445 16.9712 0.749916 -7857 6 30.1667 14.6301 35.4838 10.1392 5.1159 -4.4805 -7858 4 30.5216 15.3681 34.9096 -25.1579 -14.4294 10.0398 -7859 4 29.1929 14.5877 35.5299 11.6839 11.6021 -8.75286 -7860 6 12.5351 37.2243 16.9695 -17.9994 -5.54058 0.759354 -7861 4 12.9667 37.9067 17.4519 9.84296 27.0859 15.3185 -7862 4 13.2146 36.5653 16.9126 10.1753 -19.489 -6.1469 -7863 6 27.4306 21.5582 37.7184 0.323044 -0.91237 -2.80926 -7864 4 26.8919 21.7087 36.9418 -1.95891 -4.49412 -14.6911 -7865 4 26.9535 22.0297 38.3943 0.198826 4.23191 11.3586 -7866 6 29.6082 18.3788 12.6829 -3.7237 -11.7076 25.6006 -7867 4 29.4829 18.1024 13.618 2.9495 3.49705 -16.1413 -7868 4 28.7034 18.5321 12.3984 -4.77545 3.00323 -3.28229 -7869 6 2.3585 15.6468 0.175999 -8.20612 37.5639 57.3692 -7870 4 1.52386 15.5898 41.6501 -20.1916 -9.73007 -21.8008 -7871 4 3.00191 15.1099 41.6903 28.5072 -35.3577 -30.6151 -7872 6 17.8194 25.7234 4.22068 -18.7286 -4.35761 2.03057 -7873 4 16.8619 25.5897 3.93795 36.6055 5.10926 -2.3659 -7874 4 18.4291 25.8425 3.4621 -13.2431 -0.0346718 7.72723 -7875 6 41.7912 11.1794 20.2704 -4.7703 -4.22644 -3.97484 -7876 4 42.5222 11.2179 19.6258 -6.77094 -1.14571 2.2342 -7877 4 40.9861 11.4636 19.8126 1.73275 2.14556 -1.92771 -7878 6 38.0378 18.3863 24.0278 -3.74133 -10.331 -0.132081 -7879 4 38.4309 19.0888 24.5482 3.22643 8.24914 5.57345 -7880 4 37.9308 18.7305 23.1431 0.767244 4.53126 -6.25669 -7881 6 4.13298 13.9173 33.7521 30.6843 -35.3272 -10.2657 -7882 4 3.2388 13.7394 34.0326 -6.45696 -6.01886 0.999898 -7883 4 4.62487 13.0231 33.6052 -30.6419 39.0128 7.66426 -7884 6 19.1936 19.1847 26.5022 -1.72621 -3.50471 2.07629 -7885 4 19.5259 20.0399 26.2155 5.41694 7.89262 1.74938 -7886 4 18.9505 18.7515 25.6854 -0.500338 -7.01675 -4.74744 -7887 6 22.475 26.1945 25.3345 -21.4458 -23.9003 -3.16659 -7888 4 22.3709 25.4906 24.6814 -7.32491 -4.57374 0.352876 -7889 4 23.3013 26.5414 25.0733 33.537 19.6696 -4.44151 -7890 6 48.8098 32.073 32.5556 -12.1052 4.48194 -0.190297 -7891 4 48.9381 31.1381 32.4233 -5.03309 -16.3747 0.495313 -7892 4 49.6354 32.4434 32.2762 12.9514 12.9364 -2.07298 -7893 6 25.2177 18.014 27.013 4.13139 4.11129 3.02633 -7894 4 24.4991 17.5573 27.49 6.6231 -0.568789 -7.074 -7895 4 25.6482 17.4406 26.3525 -8.92874 -1.57445 7.95973 -7896 6 1.76475 41.5608 24.9549 2.89162 -9.06076 -21.1384 -7897 4 1.88611 40.794 24.3317 -1.07403 19.5272 24.3581 -7898 4 1.30092 0.287142 24.3881 5.67761 -7.93757 11.1942 -7899 6 18.6633 11.7702 10.8608 -14.1102 -15.1967 11.3789 -7900 4 19.5021 11.9001 10.4051 -2.67857 -1.17934 -0.0567829 -7901 4 18.6465 10.841 11.1975 0.382459 20.6246 -9.54243 -7902 6 45.6242 16.5573 4.85031 17.0541 -2.39304 -3.72853 -7903 4 46.5701 16.2411 4.85652 -23.9929 13.0597 -1.64852 -7904 4 45.6057 17.5078 4.58964 5.38323 -15.7737 4.77093 -7905 6 40.6798 36.3894 24.0177 5.99482 15.2006 -18.5281 -7906 4 40.7505 36.8152 23.1136 -3.68852 -16.1642 25.9152 -7907 4 40.7388 35.4259 23.9735 0.360603 0.79119 -4.57544 -7908 6 32.2161 36.322 4.9431 5.19197 18.2152 11.0878 -7909 4 31.5074 36.1415 4.30154 10.9387 -10.0795 -6.57323 -7910 4 33.0257 35.7839 4.88769 -13.0089 -6.05715 -7.93038 -7911 6 1.60369 14.6754 10.8168 -10.3056 7.30247 33.6992 -7912 4 2.33423 15.3134 10.9307 -7.1595 -6.86026 -1.25923 -7913 4 1.1476 14.6845 11.711 13.0511 -0.847163 -26.6328 -7914 6 35.0153 14.2871 28.0739 18.7596 2.69464 30.5166 -7915 4 34.8734 14.0618 29.0187 14.279 3.49385 -12.2543 -7916 4 34.1456 14.1907 27.7398 -26.4062 -1.19123 -20.5956 -7917 6 54.7157 6.11907 21.8609 -12.1949 -7.16094 1.89291 -7918 4 53.7846 6.03827 22.1577 10.7478 1.95047 -3.13077 -7919 4 0.0370646 6.90146 22.3147 2.89466 7.98076 3.79048 -7920 6 31.7642 16.9274 27.3665 -7.54316 -5.52924 6.90942 -7921 4 30.8348 17.1206 27.2023 -9.34166 0.83246 -0.0222557 -7922 4 32.1928 17.2544 26.5838 13.9998 7.82105 -16.2222 -7923 6 14.4504 28.0052 11.1087 -4.71237 -14.6735 4.6077 -7924 4 14.1081 28.8557 11.3451 -9.65694 14.7183 8.34222 -7925 4 14.826 28.1745 10.2406 5.25389 -7.26775 -5.19981 -7926 6 35.6627 19.4906 18.309 1.38743 3.66357 1.00844 -7927 4 36.0608 19.4502 19.1905 -8.3289 1.62604 -1.04031 -7928 4 34.971 18.8114 18.299 7.41978 2.58016 -0.85803 -7929 6 0.908295 12.7232 15.4509 -10.2874 -45.1283 5.64528 -7930 4 0.635795 11.7526 15.3361 10.0925 35.0181 2.47128 -7931 4 1.39513 12.719 16.2997 -3.76012 1.73199 -7.91518 -7932 6 52.7239 14.8052 20.9911 -10.1838 -50.8962 13.8805 -7933 4 52.1355 13.9729 20.9263 20.4043 37.1153 -0.0771148 -7934 4 52.3678 15.481 20.4204 -9.75671 2.85516 -9.21068 -7935 6 7.50014 6.78453 13.6112 45.6118 -3.77462 -0.237279 -7936 4 7.66407 7.72531 13.7166 -11.095 5.64184 -2.33744 -7937 4 8.44113 6.46934 13.5548 -33.3093 -4.56257 -1.46213 -7938 6 12.8693 29.1327 30.951 -35.1999 43.7452 -37.9705 -7939 4 12.911 28.5157 30.2274 6.73286 -14.9776 0.757022 -7940 4 13.2432 28.8129 31.7306 26.8069 -31.1286 39.1504 -7941 6 8.91269 29.9946 35.6682 4.82638 -20.5676 13.9142 -7942 4 9.08199 29.9869 36.6487 -3.4848 12.9743 -23.6701 -7943 4 8.85763 30.8835 35.2999 2.4913 8.97671 5.8399 -7944 6 29.2501 7.21193 5.56384 -35.3124 23.3999 -5.45769 -7945 4 29.8929 6.567 5.7677 24.3163 -25.3556 4.38867 -7946 4 28.4878 7.00912 6.14468 16.2636 8.35776 -7.44031 -7947 6 25.8882 9.2493 3.85609 -10.1418 -10.3657 2.14015 -7948 4 26.6938 8.77544 3.58522 -5.62061 -1.52714 -0.987441 -7949 4 25.143 8.71761 3.5088 14.4855 4.13341 2.07026 -7950 6 46.1828 19.5303 23.8452 27.5142 -8.79556 18.2338 -7951 4 47.0303 19.3932 24.4147 -29.6641 11.3761 -34.952 -7952 4 46.4302 19.9015 22.9687 10.0609 -5.49214 13.8961 -7953 6 18.6 35.3226 28.7813 33.9262 -21.2248 5.29661 -7954 4 18.5078 36.1255 28.2543 2.15121 5.76995 -5.3877 -7955 4 19.5645 35.0126 28.755 -37.0827 17.274 -2.06568 -7956 6 28.0068 22.625 32.1882 17.1638 -9.71048 -11.652 -7957 4 28.1161 23.0799 31.3381 -0.933036 0.686599 6.01892 -7958 4 27.1717 22.9224 32.5558 0.319614 0.839726 2.26602 -7959 6 25.9992 18.4251 22.6716 -8.51512 -6.6596 14.3523 -7960 4 26.8098 18.8237 22.3895 20.3106 6.57833 -11.9809 -7961 4 25.8253 18.8771 23.5162 -1.041 -7.57666 -6.79729 -7962 6 31.1689 23.0872 29.1831 -2.26749 -18.4759 6.78914 -7963 4 31.118 22.1592 28.8841 -5.05583 5.59361 3.05947 -7964 4 31.7418 23.5345 28.5581 5.1573 7.79625 -4.49352 -7965 6 36.6391 4.9259 0.480345 37.9344 10.2065 -26.5572 -7966 4 36.638 5.82198 0.886244 0.658013 -14.6584 -5.92388 -7967 4 37.39 4.95173 41.699 -35.1456 1.42767 30.4358 -7968 6 36.484 21.0145 10.0529 -6.00883 6.48187 8.17175 -7969 4 36.4042 20.1763 9.58301 3.63574 2.58382 -3.15576 -7970 4 35.8773 20.9259 10.8015 2.14778 4.06152 -0.936887 -7971 6 50.5993 25.1947 18.3919 -28.2028 12.9956 8.35013 -7972 4 49.869 24.7394 17.9262 9.19638 1.46827 3.55355 -7973 4 51.4482 24.8993 18.0848 11.0575 -8.08323 -5.33222 -7974 6 50.1824 39.6576 12.4356 -22.7811 -7.9912 15.1349 -7975 4 49.7705 38.7879 12.6194 4.75387 11.043 -2.88475 -7976 4 51.0686 39.4751 12.1603 15.8621 -1.53988 -6.37666 -7977 6 30.5412 12.4178 4.80566 -15.3128 -2.78075 25.3711 -7978 4 30.0752 11.5776 5.01806 10.6669 11.6172 -5.90727 -7979 4 31.021 12.2424 4.01172 11.531 -8.83371 -18.4272 -7980 6 28.9525 15.4713 21.8679 -2.36978 -36.4192 26.6063 -7981 4 29.1677 14.6271 22.3934 -7.66269 33.2693 -19.6276 -7982 4 28.1632 15.8063 22.3348 7.54721 -2.84859 -11.2752 -7983 6 14.0684 9.5583 16.997 2.7235 -6.59901 -0.744295 -7984 4 14.8185 8.94582 17.0717 -0.0957791 5.7783 -3.11218 -7985 4 14.4323 10.4488 16.9992 1.00571 2.57913 -1.39277 -7986 6 4.48903 30.1743 11.858 18.777 -10.7052 13.2768 -7987 4 4.86699 29.7697 12.6847 -17.3276 7.96894 -17.1216 -7988 4 3.53137 30.2861 11.9207 -0.113543 -0.314347 4.01346 -7989 6 40.8874 8.0652 23.6541 0.993335 -18.0149 -24.6412 -7990 4 41.0014 8.23968 22.6934 -0.45004 7.6784 15.1082 -7991 4 40.7726 7.0925 23.6399 1.20374 9.92563 8.58777 -7992 6 53.7462 35.0557 16.7061 9.98011 -4.48961 -22.2856 -7993 4 53.4827 35.8182 17.2307 0.000554802 6.10184 -1.96461 -7994 4 54.0786 35.3449 15.8213 -7.68991 -0.599931 23.4559 -7995 6 53.7073 10.1889 20.3718 -10.7517 16.2467 -19.4493 -7996 4 53.8408 10.0262 19.4272 8.41512 -10.415 5.03553 -7997 4 53.1338 10.9644 20.2967 0.731263 1.06205 11.7435 -7998 6 4.58979 27.075 7.78807 17.6653 -15.6715 -1.75621 -7999 4 5.19096 26.32 7.80399 16.3727 7.79792 -3.24405 -8000 4 3.78382 26.6199 7.94519 -28.415 1.42755 3.38346 -8001 6 50.5066 22.5306 22.1436 -1.2339 18.6921 5.41009 -8002 4 50.2802 23.3104 22.6632 -2.8343 -11.09 7.6214 -8003 4 50.7991 22.9414 21.3369 4.56213 -7.53044 -15.8119 -8004 6 7.04346 27.196 21.628 9.41144 -9.96736 11.8657 -8005 4 6.8407 26.6883 22.4668 -8.25713 16.2835 -27.3312 -8006 4 6.26031 27.4748 21.116 4.26862 -9.43237 15.0117 -8007 6 23.8265 35.0499 16.5937 18.3012 9.13896 26.4348 -8008 4 24.7235 34.8381 16.9269 -14.9485 7.62278 -2.13189 -8009 4 23.7604 34.5968 15.7714 -3.77201 -11.7597 -22.7393 -8010 6 5.98953 23.8983 3.91761 -44.4181 -14.5448 -1.98234 -8011 4 5.398 23.9519 3.1318 15.794 0.401012 8.45254 -8012 4 5.35617 23.6012 4.61938 19.6174 4.72778 -5.04958 -8013 6 38.7401 25.0729 19.1247 8.8169 4.91643 10.7802 -8014 4 38.7862 24.2921 18.5681 -1.99613 -8.272 -9.94687 -8015 4 39.0639 24.8191 20.0061 -2.94522 4.87881 -4.09917 -8016 6 12.9717 18.2893 10.6182 7.92512 -8.05782 -7.58833 -8017 4 12.0999 18.3162 10.2013 -2.76008 2.25331 1.21984 -8018 4 12.8722 18.6085 11.5165 -3.68712 5.29275 10.5515 -8019 6 38.0382 41.2423 21.0873 4.88219 -19.6272 -0.152698 -8020 4 37.2014 40.7765 21.2484 2.63704 8.02432 -2.02816 -8021 4 37.8835 0.198079 20.7163 -11.2369 15.8096 -5.69312 -8022 6 6.98214 22.8682 17.8394 -5.75247 -17.9204 -1.57462 -8023 4 7.61723 23.542 17.6412 15.6839 20.0065 -5.16874 -8024 4 7.3587 22.0484 17.4826 -2.13646 0.815835 3.23256 -8025 6 24.1186 19.368 12.3177 21.0449 6.23804 -24.2445 -8026 4 23.9242 19.844 13.1293 -4.19124 -3.15082 3.8784 -8027 4 23.743 18.4928 12.3308 -10.9397 -14.908 7.07664 -8028 6 44.2213 28.4415 4.8153 2.12167 -7.44997 -5.8313 -8029 4 44.3009 28.0649 3.91739 -1.37383 9.18016 5.99771 -8030 4 44.2294 29.4128 4.74855 1.01191 -3.53144 -7.03239 -8031 6 23.3167 8.29314 21.4338 -0.329791 14.7993 14.6131 -8032 4 22.995 9.23581 21.5362 7.25813 -26.2111 -7.67418 -8033 4 23.1349 8.01865 20.5229 -2.36131 4.58949 1.23489 -8034 6 14.3464 2.19127 18.5365 1.00479 -5.05512 -1.33996 -8035 4 14.3534 1.26337 18.7781 -10.0191 -8.45544 9.17935 -8036 4 15.2531 2.29149 18.2562 13.6881 11.5937 -7.27189 -8037 6 28.0536 31.92 34.134 3.57463 -14.0429 -1.6048 -8038 4 28.4517 32.4188 34.8607 -2.66641 5.35559 -0.0232853 -8039 4 27.3246 32.4577 33.7701 8.655 -3.68096 2.2403 -8040 6 53.3502 24.7032 18.2649 -24.2711 -41.2818 -9.83264 -8041 4 53.5194 24.6019 17.3193 6.96991 8.47211 -0.102973 -8042 4 53.68 25.5059 18.6169 17.7955 37.5084 3.34479 -8043 6 36.8031 28.4187 22.9511 -10.1554 -0.61119 21.2214 -8044 4 36.5106 28.9054 23.7358 4.15696 8.73481 -5.19311 -8045 4 36.1845 27.6911 23.0035 -2.36033 -17.8474 -9.79811 -8046 6 21.8885 30.5877 27.4793 -3.11585 8.28062 7.57241 -8047 4 22.2621 31.0993 28.2061 -3.96796 1.5816 4.48491 -8048 4 22.5937 30.5949 26.8475 10.2249 -8.24374 -18.6607 -8049 6 10.2833 3.28406 27.2289 -24.5304 -2.91212 14.6365 -8050 4 10.0443 2.76427 28.0065 14.6588 -5.9106 -2.57837 -8051 4 9.44832 3.75002 27.1066 2.80489 10.142 -13.305 -8052 6 37.7147 24.9939 29.6988 5.24245 -12.5023 -10.1121 -8053 4 38.3581 24.5533 29.0689 -23.3017 1.4918 23.5498 -8054 4 37.1779 24.3214 30.1874 12.7329 5.56421 -12.5271 -8055 6 9.13611 24.4367 14.4784 20.7258 8.96054 28.4908 -8056 4 9.04651 24.998 13.735 -5.03994 20.1658 -22.0876 -8057 4 8.726 23.6299 14.2398 -14.2121 -32.2206 -7.12291 -8058 6 52.7755 31.4643 7.39569 14.5412 -1.52098 0.484013 -8059 4 52.3413 32.1584 6.88884 0.00633314 4.2069 -4.47258 -8060 4 52.0605 30.9716 7.79316 -9.34275 -9.05133 5.36325 -8061 6 21.3287 5.44475 36.4975 17.176 -11.9485 -14.2877 -8062 4 20.7483 5.50715 37.2619 4.90115 -8.53405 7.77147 -8063 4 21.912 4.64524 36.5597 -18.1029 20.6035 4.94996 -8064 6 25.1768 37.2214 4.32574 4.31983 -25.8241 -7.35849 -8065 4 25.4326 36.64 3.57657 -1.88178 18.0132 5.09494 -8066 4 24.8685 36.5657 4.9694 -1.32139 10.7309 7.78615 -8067 6 33.9928 17.4475 18.2473 -28.4515 -0.0793518 28.5349 -8068 4 34.2921 17.0113 19.1053 -15.0281 13.9289 -20.2703 -8069 4 33.1064 17.9171 18.4165 33.1367 -21.5966 1.81969 -8070 6 37.9532 37.4932 25.2939 -37.7872 -15.4269 -20.4394 -8071 4 36.979 37.7096 25.1406 34.3292 -3.43428 9.43604 -8072 4 38.1084 36.7677 24.6487 1.47089 11.2608 10.0337 -8073 6 5.08061 4.87523 15.8431 -4.86231 -7.56388 -2.23136 -8074 4 5.78156 4.1744 15.8759 -9.54967 26.0091 2.46095 -8075 4 5.43258 5.75 16.0822 6.78608 -13.538 3.56789 -8076 6 14.1628 7.20449 7.78038 25.2379 -5.46067 -13.6381 -8077 4 13.5115 7.54153 8.36471 -22.6877 11.2017 23.85 -8078 4 13.6914 6.99143 6.96374 5.13235 0.836748 0.117842 -8079 6 24.9714 10.8522 38.0874 21.7543 24.8019 24.8971 -8080 4 25.3733 11.7327 37.9223 -2.75098 -14.513 10.3213 -8081 4 24.5811 10.6456 37.27 -22.0988 -18.3607 -37.1034 -8082 6 35.6792 7.98105 22.8098 -5.63995 -0.874411 -1.68631 -8083 4 36.3111 8.66137 23.0699 5.30437 2.23481 0.770305 -8084 4 35.3824 8.20038 21.9134 0.62108 2.61089 2.3422 -8085 6 24.7967 29.145 22.4166 8.97915 1.26062 2.6062 -8086 4 24.9285 28.4017 23.0307 -7.24415 3.31799 -2.87627 -8087 4 23.8684 29.1691 22.1667 -6.93063 -5.53381 0.128782 -8088 6 38.5003 31.6402 38.4666 0.118802 17.9484 -3.06973 -8089 4 38.5639 32.3894 37.8454 -0.598215 -11.959 -0.514206 -8090 4 38.3632 32.08 39.3134 -2.43734 -3.45212 12.1107 -8091 6 7.2246 33.2558 15.4144 3.93224 14.6297 14.7993 -8092 4 8.10558 33.3578 15.8508 -19.4169 -6.69939 -13.0108 -8093 4 7.30076 32.5035 14.7978 2.24681 10.3389 8.67702 -8094 6 43.3411 23.605 1.45378 1.24542 -6.52262 6.11498 -8095 4 43.1714 24.3501 0.858367 5.1295 -5.17404 3.37123 -8096 4 44.2208 23.7695 1.84296 -12.8059 2.13297 -8.4534 -8097 6 3.53981 32.9157 14.8686 -7.67856 -8.73615 6.98201 -8098 4 3.60397 33.2061 13.9566 0.668747 6.43783 -7.96574 -8099 4 3.81902 33.649 15.4236 5.03764 7.23473 -0.501009 -8100 6 25.308 21.7722 8.24708 3.37146 -12.406 14.7751 -8101 4 26.0573 21.1741 8.36562 1.41198 8.84323 -6.65363 -8102 4 24.826 21.6647 9.09095 -1.64121 7.89428 -12.8382 -8103 6 43.814 15.3562 17.763 -19.8802 -3.64728 -7.58039 -8104 4 43.4756 15.1225 16.8733 5.20247 0.973102 4.81929 -8105 4 44.7686 15.2775 17.7045 7.07231 -2.77487 -5.74422 -8106 6 15.7867 16.2594 16.6597 40.7179 11.0003 30.8626 -8107 4 16.4245 16.8568 16.2414 -0.344326 0.180624 1.74019 -8108 4 15.1074 16.2177 16.037 -41.8412 -2.72902 -33.087 -8109 6 31.9018 12.864 11.5221 -0.527288 11.9796 -2.61342 -8110 4 32.4715 13.19 12.2739 -15.261 0.218931 -18.2329 -8111 4 31.4408 13.5947 11.0331 13.5047 -10.6099 18.0399 -8112 6 18.2179 5.3463 10.1762 9.71532 5.2148 -18.3501 -8113 4 17.8204 5.66693 9.33813 -2.6575 -7.74782 15.1878 -8114 4 17.5556 5.18411 10.851 -9.29453 0.73034 -3.17809 -8115 6 23.0812 39.0781 10.9303 2.37609 8.25457 -4.90642 -8116 4 24.0025 38.8104 10.892 -1.10831 -0.594451 2.83356 -8117 4 23.078 39.9337 10.4697 -7.78026 -4.85412 5.47405 -8118 6 46.8678 33.747 8.76655 -5.11485 44.7451 24.4631 -8119 4 46.406 34.5339 8.40734 -0.304999 -21.98 -10.152 -8120 4 47.1603 34.1422 9.62028 2.09293 -20.2864 -11.5212 -8121 6 31.2447 39.9321 20.2226 -0.330123 -0.585472 -4.98228 -8122 4 30.8504 39.3151 19.5884 6.05804 4.05585 3.92388 -8123 4 32.2053 39.9316 20.0453 -4.95864 -1.44581 -1.12159 -8124 6 15.9016 33.0949 19.7876 25.1907 -5.52815 -22.1207 -8125 4 16.0748 33.7133 19.0349 -1.92202 -14.988 11.1016 -8126 4 16.5267 32.3265 19.6592 -15.8695 19.8556 5.2806 -8127 6 32.5654 39.9188 2.66304 17.6014 -10.2623 -15.3377 -8128 4 33.3417 39.59 3.14903 -11.9816 5.68487 0.865723 -8129 4 31.9971 40.348 3.29791 -5.42947 4.08066 9.69521 -8130 6 50.71 12.2088 3.91621 6.45352 -28.1924 -19.9843 -8131 4 51.4315 12.4725 3.33505 0.00989865 5.72461 1.55844 -8132 4 50.5782 12.8645 4.57223 -0.528152 29.464 22.8196 -8133 6 44.6954 2.75762 12.1022 0.941183 0.541095 5.21442 -8134 4 45.0772 1.91827 11.8337 7.97486 -4.13832 -5.1586 -8135 4 44.7961 2.76556 13.0748 -3.12194 1.26681 -13.8655 -8136 6 11.5119 11.9446 31.6555 0.0165034 5.87533 16.9496 -8137 4 11.2786 12.7291 32.193 1.1093 -4.42098 -1.85793 -8138 4 11.5615 11.2089 32.2952 3.49417 6.36211 -10.0029 -8139 6 4.75553 10.0442 10.5026 -0.613356 7.28818 -1.41717 -8140 4 5.04922 10.2458 11.3982 -0.190174 3.033 -2.19553 -8141 4 4.45357 10.8768 10.0827 4.22944 -8.29703 6.91569 -8142 6 17.1004 25.0221 20.585 20.8628 27.7333 -27.8469 -8143 4 16.2314 24.7196 20.7848 -24.892 -11.5638 6.73224 -8144 4 16.9745 25.5771 19.7683 4.93088 -15.3222 19.1034 -8145 6 48.1032 4.75801 14.8026 37.7024 -16.8658 7.41777 -8146 4 47.1817 4.923 14.9438 -21.3904 13.2232 -6.86149 -8147 4 48.4894 5.33532 14.1187 -17.354 1.23192 4.40994 -8148 6 18.8584 3.1094 3.41532 -17.9645 -5.092 -5.76247 -8149 4 18.4858 2.24853 3.65522 2.22195 0.198645 3.24183 -8150 4 19.7914 2.99202 3.55078 21.8001 -2.9136 1.99579 -8151 6 35.4214 26.4496 29.0479 -25.0869 -13.2406 8.30382 -8152 4 35.4596 27.2122 28.4766 3.66886 10.9927 -9.48044 -8153 4 36.2884 26.0622 29.0901 17.6032 -4.12101 -3.28535 -8154 6 32.3918 31.2203 12.8386 46.3164 14.9485 -1.56764 -8155 4 31.5927 31.2548 13.3118 -34.7781 -0.694705 18.2501 -8156 4 32.2274 30.836 11.9945 -8.46486 -12.2685 -25.2096 -8157 6 32.9972 28.3347 37.5978 -19.2694 -14.478 20.0019 -8158 4 32.1604 27.8545 37.87 25.9433 12.8245 -4.2723 -8159 4 33.4478 28.5699 38.4425 -10.0504 -3.89776 -17.7975 -8160 6 45.4943 24.785 10.3174 -24.9891 51.3938 13.5053 -8161 4 44.9436 25.3819 9.72852 18.6998 -28.2383 15.0369 -8162 4 45.6946 23.9769 9.88803 3.95472 -26.3164 -24.236 -8163 6 14.7646 31.7016 3.17106 -12.494 -4.77828 16.8956 -8164 4 14.1278 32.382 2.84257 8.55448 -13.727 9.9815 -8165 4 14.4774 31.2925 4.03575 0.781246 20.1514 -26.73 -8166 6 31.932 7.70259 4.29822 28.2629 -13.9597 32.9447 -8167 4 31.5142 6.8338 4.23667 -1.26054 0.464616 -4.26218 -8168 4 31.5893 8.26695 3.64018 -18.9284 22.0156 -31.588 -8169 6 42.5661 17.3076 32.2072 4.58091 20.9841 -12.8778 -8170 4 41.6153 17.2751 32.1225 -13.9289 -9.63208 0.974916 -8171 4 42.7549 18.1312 31.7017 7.23855 -15.1499 9.29454 -8172 6 13.801 23.1802 23.5544 20.5107 -9.18639 9.43365 -8173 4 13.5559 23.799 24.2431 -7.02941 8.57916 4.58982 -8174 4 14.6139 22.757 23.9348 -15.8084 7.21572 -12.2969 -8175 6 10.7224 7.09218 3.96878 16.2046 -14.1912 -58.7694 -8176 4 10.4615 7.01435 4.86228 -13.7845 -9.22242 34.898 -8177 4 10.4899 6.25858 3.45399 4.94204 24.1379 24.5516 -8178 6 28.7975 8.66057 17.8838 -26.4281 5.00156 -27.4828 -8179 4 29.5466 8.31163 17.3909 5.91048 -3.96826 -5.96201 -8180 4 28.1517 8.96764 17.1731 20.0585 -9.38402 22.2692 -8181 6 19.4445 29.3512 26.6402 -27.7559 12.8002 37.2849 -8182 4 18.9931 29.7086 27.4672 16.1765 -10.1498 -30.4371 -8183 4 20.3292 29.7071 26.6996 8.86807 3.45557 2.67965 -8184 6 40.676 40.9989 14.5783 -1.81287 -10.2023 17.4849 -8185 4 40.8703 41.6798 13.9303 10.8761 5.87921 -5.34291 -8186 4 41.4788 40.6754 15.0317 -0.103076 9.61372 -9.63617 -8187 6 46.2568 14.0853 31.7234 10.6503 -1.46249 4.93376 -8188 4 46.4506 13.1375 31.7184 -3.79774 3.42444 -0.601084 -8189 4 45.5065 14.2191 31.1522 -8.96365 0.976246 -7.34606 -8190 6 36.7103 36.3065 8.39844 -19.1971 -27.2559 -17.1971 -8191 4 36.3822 37.2167 8.51449 20.2374 -9.10083 14.9839 -8192 4 37.462 36.0245 8.9597 -8.83948 23.9771 2.75809 -8193 6 30.7983 32.4219 38.0908 -28.9564 1.76229 18.7871 -8194 4 31.3387 31.9445 37.476 23.2205 -2.83162 -11.1976 -8195 4 31.2894 33.1287 38.5298 9.85106 -3.61838 -6.87003 -8196 6 47.9 8.84746 10.1809 13.9026 13.2481 4.99334 -8197 4 47.2314 9.07534 9.54683 -14.9306 19.0332 -8.73943 -8198 4 48.008 7.93273 10.003 10.2061 -26.7512 4.08493 -8199 6 24.4282 17.0027 30.9766 -8.14946 0.47403 -13.61 -8200 4 23.7021 16.9118 30.3187 14.132 0.581257 9.28124 -8201 4 24.0019 17.1514 31.8341 1.66288 -1.35228 -5.87998 -8202 6 40.5039 5.09263 4.48513 -8.56504 -6.5373 -32.2613 -8203 4 41.2755 5.64065 4.37578 16.2932 9.35997 9.97847 -8204 4 40.1843 5.0523 3.55179 -2.89742 -7.45623 19.6864 -8205 6 52.5794 28.086 6.91602 -27.2154 -20.1235 6.97783 -8206 4 52.4353 28.6007 6.11552 3.94928 -0.112987 0.705634 -8207 4 51.6969 27.6552 7.08025 27.1089 14.7333 -4.60736 -8208 6 36.0629 32.381 23.6142 9.17579 -16.9148 -2.4755 -8209 4 36.5407 32.2813 22.7776 -1.15674 3.38979 7.41153 -8210 4 35.7113 33.2654 23.6252 -9.15386 11.2493 0.0331211 -8211 6 23.6552 31.8756 22.7565 -25.0136 1.00336 21.6204 -8212 4 23.73 32.5959 22.1297 15.1034 -2.64982 -11.1407 -8213 4 24.3343 31.2055 22.6866 12.2933 -0.39941 -10.0267 -8214 6 0.736598 24.4641 41.7072 -6.94393 1.55048 -19.4095 -8215 4 1.23654 24.8288 40.9522 -3.95743 -2.80997 9.51773 -8216 4 54.8325 24.2702 41.3637 13.4109 4.08216 3.5339 -8217 6 15.9721 8.97822 19.8125 19.0517 -22.613 16.6544 -8218 4 15.5497 8.29105 19.3091 -4.28185 -9.24838 -10.3339 -8219 4 15.6128 9.78815 19.5092 -16.7051 35.4763 -13.493 -8220 6 33.1656 12.5735 20.0353 32.8597 -32.3881 -24.7893 -8221 4 32.9817 11.6196 19.8453 -6.04217 28.6875 8.28399 -8222 4 34.1172 12.6638 19.7368 -32.1809 10.6792 11.3696 -8223 6 7.04894 24.9401 26.3957 -12.3425 -2.00741 -5.21086 -8224 4 6.75821 24.2907 27.0478 8.01299 -1.99342 6.24335 -8225 4 7.89161 25.3154 26.6505 10.7219 -3.29246 12.7441 -8226 6 44.479 22.5508 36.9163 -6.8399 -5.44184 13.3083 -8227 4 43.5214 22.4098 37.071 12.5044 3.3732 -3.51472 -8228 4 44.595 22.7899 36.0028 -4.86816 3.42784 -13.6235 -8229 6 39.2745 23.7032 25.1197 -32.3737 -81.7274 9.17932 -8230 4 39.5886 24.5492 24.9992 24.471 68.8814 -13.2187 -8231 4 38.7456 23.4691 24.3377 5.22396 6.33701 6.85867 -8232 6 20.3646 2.19602 36.9892 -4.85825 6.83938 3.69158 -8233 4 20.3067 1.45038 37.5971 1.4243 -8.23943 -2.36696 -8234 4 20.3942 1.88275 36.0861 3.42557 -6.35335 -2.19064 -8235 6 22.8664 19.5513 3.67104 -13.2265 5.28042 31.2857 -8236 4 22.7633 19.8561 4.6286 7.01101 -9.22167 -32.7463 -8237 4 23.7764 19.7315 3.39612 4.00916 2.85623 5.02623 -8238 6 31.705 12.5768 34.6039 18.8969 7.7197 42.0834 -8239 4 31.1026 13.3107 34.9476 21.2302 -23.3848 -5.30166 -8240 4 32.3569 12.3026 35.3493 -33.8624 17.1964 -33.567 -8241 6 12.9851 10.2105 25.0956 -25.1193 26.0078 -38.429 -8242 4 13.6149 10.0452 25.7619 22.39 -15.9831 32.7066 -8243 4 12.4963 9.40655 24.9468 1.34194 -14.9569 1.62555 -8244 6 27.2621 0.584423 13.2176 -28.6404 -16.2485 2.71576 -8245 4 27.7069 41.6292 13.1518 2.13728 8.59646 -2.51953 -8246 4 26.2847 0.395264 13.1771 23.0038 6.72582 -0.601928 -8247 6 5.66006 24.9398 13.9833 -7.43295 9.91556 10.5591 -8248 4 4.70147 24.9177 13.9802 -4.26929 -7.73667 -8.07402 -8249 4 5.82197 25.381 14.8221 8.41297 -1.15026 -0.763214 -8250 6 22.9908 17.9523 0.521723 7.02411 -25.4698 12.909 -8251 4 22.4592 18.6506 0.142784 -9.22706 3.46645 -2.83539 -8252 4 22.3527 17.3052 0.930771 13.2695 22.3169 -13.3733 -8253 6 33.0935 25.4243 5.46557 -9.38497 -10.8046 -8.60877 -8254 4 33.4966 26.2756 5.44764 14.9521 17.8538 5.01915 -8255 4 32.9941 25.2035 4.5344 -2.6207 -6.96629 2.5324 -8256 6 8.53079 7.95552 17.4804 7.64086 6.41223 -26.4035 -8257 4 9.4001 8.35547 17.2638 -9.73917 -4.33322 7.64386 -8258 4 8.4487 7.94255 18.4286 4.30191 2.70426 16.6029 -8259 6 26.8371 0.685906 2.89773 -0.256761 31.01 4.86999 -8260 4 26.7806 0.433187 3.83156 0.637082 -2.67537 2.60738 -8261 4 26.6279 1.66343 2.89109 6.9325 -26.481 -2.08778 -8262 6 50.0417 34.7142 15.6334 -23.0288 8.72534 -30.9996 -8263 4 50.5531 35.2159 14.9759 6.02412 -4.51102 12.1494 -8264 4 49.1615 34.6714 15.1751 14.0914 -5.62478 19.352 -8265 6 46.2791 4.99946 11.1196 9.7179 12.4772 -7.72995 -8266 4 45.7827 4.25534 11.4529 -10.6417 -11.5364 6.26713 -8267 4 46.9456 4.6214 10.5389 1.00953 -4.68959 -1.2994 -8268 6 33.7936 38.6123 35.3918 15.2762 25.882 47.4359 -8269 4 34.0305 39.0866 36.2411 -6.18084 -28.1229 -24.2145 -8270 4 33.6134 39.3784 34.8506 -5.42867 -1.33428 -20.4371 -8271 6 30.8282 25.8371 41.2172 -7.09757 -19.9215 -22.3179 -8272 4 31.1427 24.9253 41.375 1.19635 8.28989 4.89631 -8273 4 31.1138 26.3841 0.0263053 10.2845 10.2166 22.0109 -8274 6 50.2275 0.982033 24.4751 51.8832 -7.79127 14.7425 -8275 4 49.5671 0.561213 23.9746 -37.5145 -10.5742 -20.1648 -8276 4 51.0349 0.46072 24.2534 -17.6876 18.8276 11.0022 -8277 6 31.2908 0.710797 19.047 -2.09434 13.573 -1.22083 -8278 4 30.4487 0.672221 18.611 -14.5784 9.11804 -11.7691 -8279 4 31.2841 41.7946 19.4765 8.98672 -35.4229 20.9418 -8280 6 39.0741 29.5515 19.1276 -25.3595 -21.9961 15.137 -8281 4 38.1807 29.4949 19.565 25.109 7.94863 -12.7917 -8282 4 39.4837 28.6866 19.3452 2.49072 15.8212 -6.56848 -8283 6 21.6546 17.5955 25.8962 -6.78298 15.7545 0.118362 -8284 4 22.0482 18.4938 26.0891 -15.3421 -24.4294 -5.96834 -8285 4 20.8112 17.7106 25.4012 18.8301 2.25602 6.45745 -8286 6 35.0761 28.7988 27.4227 3.11164 -5.22767 30.3338 -8287 4 35.4099 29.4705 28.0422 -1.31539 -7.25274 0.820077 -8288 4 35.176 29.229 26.5925 2.58985 10.308 -31.8228 -8289 6 30.7102 25.4463 11.6589 -5.09223 14.513 32.8165 -8290 4 30.6059 25.8179 12.6014 3.72506 -14.6402 -39.0718 -8291 4 30.6061 26.1982 11.055 2.14208 -0.820709 7.44645 -8292 6 7.34821 15.124 12.3469 -7.98455 -28.7648 8.02815 -8293 4 6.65824 14.4547 12.1585 7.38491 7.52419 4.72727 -8294 4 7.19665 15.7511 11.658 -2.78105 24.4343 -15.0907 -8295 6 16.8417 26.815 7.05419 -24.774 6.28148 -21.5195 -8296 4 17.6138 26.5995 7.5418 30.7131 -10.23 16.3776 -8297 4 17.1302 26.9688 6.14022 -2.93816 -3.28182 4.8763 -8298 6 29.5112 33.0571 30.9901 -17.2684 21.8413 -16.809 -8299 4 28.6007 32.8494 30.6893 8.91061 -10.9491 6.08618 -8300 4 29.8939 32.355 31.5124 -6.62171 -19.0922 5.25725 -8301 6 14.1054 2.12143 30.9174 -7.90077 -11.4283 37.211 -8302 4 14.0041 2.00138 31.9209 0.0297695 4.78336 -39.0496 -8303 4 13.7376 1.30679 30.5176 6.48361 9.45743 4.44265 -8304 6 15.6593 22.2688 2.88796 -26.3773 12.8308 -8.6958 -8305 4 16.4059 21.7286 3.01985 35.1738 -16.1657 6.55343 -8306 4 15.0005 21.6175 2.62854 -10.183 2.33344 0.69621 -8307 6 23.7324 29.1178 40.9691 12.375 28.71 1.88761 -8308 4 23.2563 30.0016 40.9795 15.1309 -27.3218 0.73938 -8309 4 24.7153 29.2815 40.9372 -24.8849 -3.40565 0.339466 -8310 6 38.1289 14.1609 13.7163 11.3988 23.3452 4.961 -8311 4 37.6355 13.3641 13.8052 -15.0683 -25.2976 3.04519 -8312 4 38.877 13.9408 13.1592 7.07353 -0.711776 -7.39216 -8313 6 35.2564 26.5047 15.5196 1.21661 4.3606 12.6683 -8314 4 34.5556 26.4436 14.8616 -0.145442 -0.409522 -0.299569 -8315 4 34.9009 27.0522 16.256 4.1263 -8.75979 -17.8666 -8316 6 19.0944 34.7315 16.477 3.93496 0.874554 38.8769 -8317 4 19.5342 35.6013 16.5498 -2.87948 -9.96323 -9.99674 -8318 4 19.0181 34.4301 15.5899 3.71142 3.01681 -30.4069 -8319 6 18.1805 29.7449 35.7046 18.8444 17.1873 -3.97052 -8320 4 18.2235 30.6593 35.335 -4.4784 -20.2666 13.1463 -8321 4 19.056 29.5886 36.1261 -9.76671 1.23141 -6.47371 -8322 6 54.1188 22.2659 24.9096 4.78421 -24.6774 -19.3149 -8323 4 53.6441 21.8104 24.1769 10.121 5.11789 9.9801 -8324 4 53.5075 22.9378 25.1661 -14.3198 20.1313 5.7187 -8325 6 30.3323 10.3375 34.0061 7.35563 0.641124 -2.21855 -8326 4 29.5734 10.4043 34.5817 -14.4555 0.0376959 9.72957 -8327 4 30.8213 11.1653 34.1487 -3.17747 -4.67635 -0.590304 -8328 6 38.3211 33.8974 18.5888 -1.32754 -0.89807 -0.720993 -8329 4 38.9926 33.271 18.8539 2.22312 -19.1913 3.89796 -8330 4 38.8713 34.6655 18.5317 3.84957 24.8056 -1.31283 -8331 6 22.4809 14.1697 34.431 -22.1622 -5.27184 -37.8541 -8332 4 22.5433 13.5186 33.673 0.822047 20.8222 24.5167 -8333 4 23.1773 14.0067 35.0533 16.0768 -5.18569 10.3575 -8334 6 38.0141 0.622036 2.34694 9.03481 -5.1652 10.3599 -8335 4 37.7113 1.09641 3.1189 -18.3016 16.1314 2.00329 -8336 4 38.7028 0.120019 2.79986 6.1006 -11.8827 -16.4842 -8337 6 38.8847 41.1446 10.3004 16.8495 57.0142 -12.497 -8338 4 38.6453 0.212884 10.3117 6.47193 -33.8599 -1.337 -8339 4 38.2374 40.7573 10.8541 -26.8649 -17.5582 22.9746 -8340 6 53.4109 21.9211 38.9712 27.3607 0.0645619 -10.5759 -8341 4 53.0384 21.9801 38.0859 -10.7304 2.2749 -0.0111998 -8342 4 54.3668 22.0571 38.7395 -19.1981 -5.88632 12.9741 -8343 6 39.9872 12.7205 36.288 -8.06793 35.3321 20.4333 -8344 4 39.087 12.3834 36.3725 1.18883 -9.13664 -3.11406 -8345 4 40.4905 12.1818 35.7009 7.36107 -20.124 -19.0601 -8346 6 48.4463 17.2389 40.5967 -24.7278 4.81563 12.4078 -8347 4 47.5665 17.6971 40.4852 25.7833 -12.0744 1.257 -8348 4 48.3987 16.886 41.5134 6.10343 4.05346 -12.6042 -8349 6 32.0413 9.35688 40.0251 1.84943 -9.41379 10.5137 -8350 4 32.8011 9.3156 39.4233 -4.71533 -3.42986 0.347912 -8351 4 31.8082 8.43016 40.2864 3.98001 20.4877 -6.20043 -8352 6 31.7351 22.4909 6.36481 -11.9835 4.517 5.86255 -8353 4 31.4453 21.6589 6.79738 2.31245 15.2673 -2.59345 -8354 4 31.3521 23.2372 6.88711 4.39127 -22.2776 -7.77946 -8355 6 51.0252 2.58567 21.5888 12.0252 -3.79771 4.1956 -8356 4 51.3852 1.69652 21.8042 -1.91984 13.1306 -1.09782 -8357 4 51.7712 3.19849 21.4753 -6.25067 -9.48202 2.92476 -8358 6 13.6387 22.0486 12.1519 25.289 13.6281 9.24284 -8359 4 14.4553 22.4795 12.4841 -9.12946 -7.35477 -7.44936 -8360 4 12.9422 22.6971 12.3091 -5.69931 -0.254566 -0.690626 -8361 6 23.6098 24.0343 14.6404 -2.85842 21.3712 -30.1324 -8362 4 24.3054 24.4792 15.1401 1.72137 -5.65962 3.08819 -8363 4 23.5196 24.6041 13.8393 -4.42688 -17.9982 21.1692 -8364 6 9.32217 4.85318 31.2328 11.4746 -4.61869 -4.10735 -8365 4 8.43042 4.86168 30.8848 -9.06213 4.49291 -0.279243 -8366 4 9.25495 5.26013 32.106 -3.85952 -1.36 2.0258 -8367 6 16.6786 26.3118 18.041 -30.5179 5.83101 -14.1852 -8368 4 15.8205 26.6594 17.6987 9.23568 -14.6779 7.38956 -8369 4 17.2149 27.0871 17.9121 20.6972 11.6613 1.32787 -8370 6 5.1068 13.5155 11.5503 -9.62018 18.629 -29.2057 -8371 4 4.37741 13.3629 12.1623 -7.62379 -0.222526 0.540006 -8372 4 4.70689 13.979 10.7366 10.5209 -18.4088 37.9064 -8373 6 29.6181 23.6359 8.06142 -1.81854 7.21422 -1.70755 -8374 4 29.1888 23.4521 8.90141 0.206013 -3.23773 -0.0922606 -8375 4 29.4815 24.5976 7.98987 7.61073 -10.2969 -5.72522 -8376 6 0.801466 7.54671 27.8401 6.5354 -3.49578 -14.7683 -8377 4 0.895859 7.27352 28.7573 1.78004 -0.979843 7.25552 -8378 4 1.54585 8.15528 27.6648 -11.1939 -10.5496 5.25649 -8379 6 15.4336 9.77253 0.489553 0.922542 4.3707 -1.35473 -8380 4 16.0351 9.34865 41.7726 4.14277 -6.55565 2.56274 -8381 4 15.4857 9.31476 1.34042 4.74784 -1.15717 -0.337147 -8382 6 18.8008 0.0730809 34.105 -10.3773 -6.96418 -21.8764 -8383 4 18.5081 41.5423 33.2731 5.22569 12.9238 15.5106 -8384 4 18.5071 0.998566 34.0742 -2.68781 1.40869 -5.2752 -8385 6 18.7326 30.7673 29.1559 48.9948 -22.8293 28.8452 -8386 4 19.5421 30.7479 29.7792 -35.6741 -9.01286 -31.0748 -8387 4 18.496 31.6741 29.187 -17.0068 24.787 -0.45657 -8388 6 48.459 16.4997 36.139 1.45519 10.5028 1.01521 -8389 4 47.6111 16.9857 36.2164 10.4415 -5.87096 -2.55811 -8390 4 48.4968 16.1176 35.2432 -2.18798 4.21486 5.30298 -8391 6 43.8007 0.467658 29.2569 28.3678 -13.8677 -3.77703 -8392 4 42.8971 0.305725 29.4937 -25.3214 -1.14832 5.94808 -8393 4 44.2622 41.5592 29.5347 -3.4854 12.8866 -0.12306 -8394 6 16.7282 13.8764 21.3804 -5.85841 5.25102 8.86173 -8395 4 16.2274 14.7005 21.5266 6.94274 -6.60805 -7.01164 -8396 4 16.607 13.4327 22.2267 1.29648 -4.09529 1.45702 -8397 6 17.3848 13.434 26.2514 27.8708 0.579352 -19.8612 -8398 4 18.2073 13.6243 25.7048 -28.5107 -7.2193 21.7409 -8399 4 17.5944 12.6077 26.718 -2.1357 3.12496 0.608863 -8400 6 48.1647 10.2208 23.7049 7.80266 -18.7522 13.388 -8401 4 47.9825 10.5204 24.6118 -3.05612 1.76991 -8.97221 -8402 4 48.0139 10.9468 23.1026 -1.19683 7.34816 1.26356 -8403 6 28.2773 17.9142 17.8758 3.72989 18.9709 -15.182 -8404 4 29.0682 18.432 17.6259 -4.1904 -8.84834 4.2635 -8405 4 28.5441 17.0749 18.25 8.7895 -11.8779 5.35139 -8406 6 54.0848 38.1774 23.6862 8.79068 2.20397 4.23058 -8407 4 0.0366427 38.003 23.4974 -14.1536 0.885634 -1.20583 -8408 4 53.5245 37.5494 23.203 6.54807 -0.952262 -0.611804 -8409 6 8.48984 18.3998 11.4055 -13.462 -3.57414 27.789 -8410 4 7.65602 18.6961 11.043 -9.38292 3.75479 -0.915161 -8411 4 9.09748 18.5243 10.712 30.3826 3.02886 -30.4498 -8412 6 45.9441 12.8818 11.0222 -16.4049 1.91652 -6.40765 -8413 4 46.711 12.6299 10.4835 -7.54952 -0.564906 -6.57768 -8414 4 45.1235 12.7466 10.4771 21.7466 0.735613 7.10643 -8415 6 16.2215 8.79448 14.033 27.9098 -14.9816 6.01142 -8416 4 15.5522 9.3752 13.7952 -53.829 20.9905 -11.5495 -8417 4 16.9359 9.40542 13.9326 31.9466 3.3348 3.59486 -8418 6 42.7223 13.3863 21.3918 29.8224 16.7773 6.64199 -8419 4 41.9142 12.8874 21.2836 -9.67718 -3.29752 -8.9243 -8420 4 42.6271 14.312 21.0975 -16.0363 -11.184 0.152454 -8421 6 20.9977 40.4228 16.4707 19.2311 -21.9074 5.84064 -8422 4 20.7341 40.0536 17.3362 -0.495629 5.04161 -8.05599 -8423 4 21.8212 39.937 16.2081 -24.2166 11.8961 5.45251 -8424 6 45.6397 11.4296 32.9439 38.4109 -29.1814 -9.99274 -8425 4 46.3321 10.7493 33.2028 -28.4056 24.9384 -5.22126 -8426 4 45.113 11.6624 33.7013 -7.79747 1.97566 18.4384 -8427 6 26.9602 8.8599 24.2968 13.5915 2.79356 4.8338 -8428 4 27.3951 9.75608 24.2837 -6.20264 -27.5971 5.81865 -8429 4 27.4821 8.2415 24.8764 -5.62896 20.549 -11.158 -8430 6 18.9707 2.44141 29.3655 -2.01209 17.0873 0.653095 -8431 4 18.2519 2.38593 30.0124 -1.45633 -1.83702 1.76482 -8432 4 19.0982 3.39915 29.1871 -0.208097 -9.69202 4.76181 -8433 6 8.2396 29.1642 19.724 -7.67611 -9.48635 17.3168 -8434 4 8.16332 28.9052 20.6672 2.00381 4.74558 -18.2193 -8435 4 7.79264 28.4685 19.2154 1.97612 2.42161 3.19163 -8436 6 9.03293 34.3085 18.6392 -6.8245 -3.51508 -5.57673 -8437 4 8.73043 34.3576 19.5508 2.61936 3.47829 -5.40237 -8438 4 9.19173 35.2194 18.3614 3.83285 -0.179546 -0.301582 -8439 6 10.1806 11.9309 11.2378 5.33181 -8.21116 5.18339 -8440 4 10.4199 12.8404 10.9987 -8.38943 -3.43734 -3.26379 -8441 4 9.2213 11.8063 11.1618 4.16708 15.3888 -2.40164 -8442 6 35.7388 21.6853 36.1571 -21.2187 21.2566 3.59668 -8443 4 35.0074 22.3505 36.1843 15.9506 -16.0405 0.715421 -8444 4 36.3839 21.978 36.8321 -7.05156 -5.2756 -8.86951 -8445 6 17.0774 12.5078 36.39 -5.14261 15.8003 12.7424 -8446 4 17.3404 12.7479 37.2961 -4.35419 -1.09545 -7.6232 -8447 4 17.4977 11.6659 36.234 4.71638 -15.3379 -7.50181 -8448 6 37.1607 13.034 34.2837 0.889917 6.85814 -56.1323 -8449 4 36.6144 12.2451 34.135 3.16712 2.80772 8.73621 -8450 4 37.2953 13.1592 35.1962 -1.91867 -3.10361 40.6259 -8451 6 38.9747 29.5563 13.2253 1.18838 24.1885 -12.4362 -8452 4 38.8174 28.6959 12.8484 -2.87796 -16.626 0.178868 -8453 4 38.7606 29.548 14.1582 -0.666122 -3.30753 9.89159 -8454 6 0.17037 29.343 29.4884 -1.26324 3.91124 -27.2421 -8455 4 0.785297 28.6867 29.1327 1.78511 -2.78426 6.40223 -8456 4 54.9717 29.8735 28.6813 -2.47422 -4.8209 18.3172 -8457 6 15.9286 0.264913 12.7638 2.77369 8.97324 -0.606717 -8458 4 15.3998 0.564835 11.9867 -4.35739 -9.72902 15.1241 -8459 4 15.3918 41.7399 13.4663 -4.26125 7.58409 -15.055 -8460 6 3.98508 11.9472 8.79546 -10.0423 -23.9471 10.8905 -8461 4 4.30821 11.7435 7.92681 6.40121 -7.70989 -16.6116 -8462 4 3.96465 12.8834 8.77069 -2.75643 37.1798 9.03734 -8463 6 24.0517 23.6768 19.9772 9.9875 -0.396554 0.578582 -8464 4 23.5025 22.9354 19.7663 -8.47693 -16.0962 -5.40355 -8465 4 23.4442 24.2751 20.4024 2.14545 13.6845 6.88162 -8466 6 4.48152 2.30986 23.9923 -27.0109 23.4084 27.373 -8467 4 4.59263 2.40669 23.0716 9.73085 -3.6317 -36.525 -8468 4 3.6479 2.81506 24.1139 10.3345 -10.6947 10.8816 -8469 6 33.0856 27.6588 33.8383 -8.68317 -6.77689 0.893276 -8470 4 33.3543 28.5605 33.6822 -2.66039 14.7626 -6.22211 -8471 4 33.7694 27.2718 34.3804 4.93538 -5.90298 8.33006 -8472 6 11.4012 21.7076 6.08442 -20.9181 -7.28975 6.20623 -8473 4 12.3452 21.6439 6.06884 23.6791 -0.506282 -5.12853 -8474 4 11.1369 22.1078 5.25059 3.06155 -0.534748 -3.52863 -8475 6 37.2275 13.5312 23.6107 -13.7454 14.8127 9.96245 -8476 4 37.2011 14.0176 24.4689 -4.04457 -8.03454 -15.7104 -8477 4 38.0738 13.1109 23.5305 19.2281 -7.80113 -1.86698 -8478 6 5.00929 21.0475 33.3676 1.03993 27.0325 -33.9401 -8479 4 4.24931 21.2691 32.771 13.0002 -8.94008 10.7478 -8480 4 4.70945 20.492 34.0664 -10.4226 -16.4153 18.9759 -8481 6 18.2024 37.5737 26.9347 11.0126 -1.54132 -8.69207 -8482 4 17.8515 38.4557 27.1129 2.92195 -1.85995 -3.39903 -8483 4 18.9058 37.6892 26.2602 -8.80934 -3.84756 9.96821 -8484 6 19.7475 16.1502 4.67922 -0.59461 -5.69737 6.80756 -8485 4 18.938 15.9829 5.17999 -0.503733 6.42822 -3.53139 -8486 4 20.452 15.899 5.29485 1.51569 2.54074 -3.7554 -8487 6 54.0588 32.502 15.5791 2.11509 -30.3723 -27.0265 -8488 4 54.9193 32.2734 15.944 -2.03587 2.87368 2.60187 -8489 4 53.7148 33.1889 16.1175 -9.21817 24.1266 16.9863 -8490 6 31.1319 3.81908 36.7331 -8.52453 -12.3767 5.98224 -8491 4 31.0251 4.01663 37.6709 2.24281 6.85123 1.97341 -8492 4 30.7371 2.93942 36.6325 4.48759 4.53933 -4.77061 -8493 6 11.8397 14.3559 5.95013 17.712 13.5011 32.6048 -8494 4 11.8882 13.4483 5.64785 3.21485 -4.29204 1.16864 -8495 4 12.4103 14.428 6.79608 -23.3682 -9.2254 -38.5841 -8496 6 30.4732 33.6903 6.46877 -20.5926 30.9984 10.0988 -8497 4 30.0823 33.146 7.15741 -0.571027 -8.82817 5.88036 -8498 4 31.0368 33.1406 5.95739 18.3645 -25.6031 -16.3825 -8499 6 12.7874 0.539502 21.6719 -8.5062 -5.44338 -19.1545 -8500 4 12.0427 0.939271 21.1459 16.6961 -1.79193 22.1421 -8501 4 12.8959 0.982969 22.5241 -5.23507 7.86641 1.50036 -8502 6 52.7588 7.2218 26.198 16.8025 28.3515 6.33153 -8503 4 53.4065 7.96379 26.3423 -21.978 -17.2249 -4.05545 -8504 4 53.0631 6.80021 25.3976 -2.37526 -6.61619 -6.13258 -8505 6 39.7335 40.8867 3.73325 7.25622 8.93714 -16.4459 -8506 4 39.3445 40.0379 3.8542 -7.03998 -23.1188 -2.87281 -8507 4 39.6833 41.2661 4.59764 3.93702 15.0893 17.324 -8508 6 20.121 31.9222 21.9838 -6.71526 -6.20654 6.86321 -8509 4 19.4522 31.9772 22.708 13.7594 -4.46219 -12.9776 -8510 4 20.3423 32.8279 21.7497 1.41177 8.86705 -0.575134 -8511 6 12.8675 35.0031 4.45346 44.828 -17.7313 4.60062 -8512 4 12.2237 35.6716 4.40701 -39.658 29.9319 -2.18346 -8513 4 13.7076 35.4677 4.24983 -7.53722 -6.26381 -0.0905995 -8514 6 24.0625 33.6591 24.8433 7.47563 8.71661 -6.22666 -8515 4 23.7256 32.9086 24.3593 -5.011 -9.84395 -6.229 -8516 4 24.8651 33.8891 24.3525 -1.08488 0.504411 0.449776 -8517 6 40.1566 40.8925 22.745 3.65995 -18.1772 23.084 -8518 4 39.459 41.1173 22.1514 -10.4135 8.7075 -19.9273 -8519 4 39.655 40.5713 23.5068 11.7186 -0.819555 2.88668 -8520 6 15.5608 2.83174 38.4548 -17.961 4.93292 18.3513 -8521 4 14.8017 3.44348 38.6509 23.1729 -8.01231 -13.692 -8522 4 16.317 3.27039 38.0376 1.48109 9.53369 -0.90723 -8523 6 41.0116 9.17543 16.9495 15.4695 -4.08523 -13.4682 -8524 4 41.9148 8.77619 16.8957 -14.8555 5.86712 4.74383 -8525 4 40.5932 8.80873 17.73 -3.00249 -3.47282 8.63794 -8526 6 43.1871 41.3934 9.57744 -8.69666 -18.4537 3.1119 -8527 4 42.3844 40.9156 9.26306 10.8189 9.37287 1.53096 -8528 4 43.2581 0.273962 9.04681 -5.03874 9.79533 -5.6553 -8529 6 24.9044 37.9223 30.7828 -39.5154 -3.84946 22.9815 -8530 4 23.9949 37.8093 31.2426 42.0603 4.56965 -20.1335 -8531 4 24.7148 38.3736 29.9542 -2.24489 2.04808 -5.58176 -8532 6 2.22015 5.33054 16.4399 10.309 -8.52293 4.98471 -8533 4 1.84892 4.56193 16.8809 -9.36945 -1.25887 4.31387 -8534 4 3.13742 5.05729 16.2666 0.349453 6.20437 -4.74718 -8535 6 1.39717 14.946 19.1428 25.1228 15.6369 3.14315 -8536 4 0.624759 14.5201 18.7755 -11.3456 -6.79531 3.66607 -8537 4 1.29195 14.9418 20.1112 -7.64559 -2.97115 -5.19376 -8538 6 34.323 26.551 23.7054 -6.89575 15.1076 -7.90432 -8539 4 33.5377 26.6273 23.1515 0.482254 10.7241 -2.26295 -8540 4 34.2298 25.6735 24.0419 5.3831 -21.6418 13.1607 -8541 6 41.9187 21.8289 37.5387 -12.5221 18.6557 -0.654717 -8542 4 42.0641 21.2774 38.3263 -4.73604 7.9145 -4.0056 -8543 4 41.3184 22.5612 37.831 11.9642 -17.2916 1.51119 -8544 6 39.4187 37.6728 12.6286 4.8532 5.57593 -2.65087 -8545 4 38.7905 38.0203 13.2933 13.4683 3.10916 -9.30227 -8546 4 40.0129 38.4033 12.3216 -17.7433 -13.1833 12.1033 -8547 6 30.24 35.8848 2.88572 49.7685 -5.59713 18.4489 -8548 4 29.7974 35.0543 2.80033 -9.93294 -19.906 -6.06696 -8549 4 29.6668 36.5692 2.63166 -32.6151 32.1739 -11.9765 -8550 6 50.3574 12.2906 11.0327 -10.5999 -17.0186 -10.0309 -8551 4 50.5337 13.0768 11.5186 9.60091 28.0994 7.49192 -8552 4 50.105 11.6994 11.7365 -4.43527 -18.2768 5.14926 -8553 6 38.4177 1.51331 34.6454 7.78381 -17.0522 33.0946 -8554 4 38.2699 2.04814 33.8899 -7.54861 16.9144 -29.9652 -8555 4 38.0471 0.642488 34.4678 -6.5188 -5.83242 -9.72252 -8556 6 23.4539 32.2409 29.2188 -19.2438 22.9381 45.5983 -8557 4 24.0079 32.8299 28.7229 8.54827 0.527122 -15.0299 -8558 4 23.2413 32.797 30.0413 4.80705 -31.5817 -31.7916 -8559 6 36.5701 38.8746 8.90535 32.3223 -9.33237 29.2552 -8560 4 35.9325 39.4424 8.49935 -20.4423 23.0824 -8.61697 -8561 4 36.7801 39.1579 9.82993 -12.7327 0.605838 -19.3651 -8562 6 35.8737 15.8498 32.4386 8.92141 19.9053 -4.5399 -8563 4 36.1418 15.4504 33.2665 1.19933 -3.86396 7.25653 -8564 4 36.5179 16.5897 32.2945 -14.9335 -15.4114 1.1633 -8565 6 22.2892 21.8291 41.5841 -16.2626 10.7882 17.5339 -8566 4 22.1223 22.8053 41.6744 16.5914 -23.4811 -7.73209 -8567 4 23.1242 21.6534 41.1409 10.4107 9.35007 -4.50107 -8568 6 24.3606 38.6964 37.0146 17.4204 12.5043 -4.63866 -8569 4 25.2779 39.064 36.9978 -17.1771 -5.52971 -1.04157 -8570 4 24.4186 37.9719 37.6407 -4.78215 -9.12154 5.30794 -8571 6 45.8441 22.068 16.038 0.340293 -0.250982 -17.8101 -8572 4 46.1771 22.3609 15.1533 -8.50833 -8.1377 19.1007 -8573 4 45.4344 21.1785 15.9468 10.2139 13.0315 -4.03882 -8574 6 34.0918 26.1359 39.6112 38.0511 -8.91464 13.1738 -8575 4 33.1848 26.2338 39.3827 -25.4265 4.60567 1.8853 -8576 4 34.221 26.2032 40.5833 -12.0295 -1.62025 -11.2558 -8577 6 7.22533 36.1661 23.281 -59.3132 -5.14125 -34.652 -8578 4 7.26364 37.0581 22.9295 6.20379 9.34593 -2.3157 -8579 4 7.97006 36.0735 23.8015 59.451 -4.11437 40.0555 -8580 6 29.1637 40.7448 9.14206 -2.51826 7.72751 -13.9009 -8581 4 29.0444 40.3656 8.22324 15.9504 -2.90487 33.8878 -8582 4 29.7314 40.248 9.77766 -4.36215 -9.31282 -20.9127 -8583 6 29.3678 11.2357 1.30083 -35.1077 14.24 19.1284 -8584 4 28.4669 11.4731 0.940057 29.2946 -5.02339 11.2991 -8585 4 29.318 11.4379 2.27092 4.83193 -7.95866 -28.0539 -8586 6 30.9732 3.71267 14.0776 15.2348 -46.8383 -31.5788 -8587 4 31.4582 2.88428 14.3733 -12.5046 34.6753 7.46482 -8588 4 30.8397 3.49874 13.1133 -3.67459 15.4991 23.3176 -8589 6 29.7056 15.2804 38.2794 -11.9618 14.5562 -33.6413 -8590 4 30.2702 15.1354 39.0168 20.1567 -4.59268 23.419 -8591 4 30.0841 16.0123 37.7308 -6.59039 -15.0688 15.6005 -8592 6 36.6264 0.310111 29.1514 -5.04796 -7.83703 -2.09784 -8593 4 37.4271 0.819379 29.3706 -8.93441 4.46737 -4.0897 -8594 4 35.9914 0.856083 28.6484 15.2391 -5.29618 7.37908 -8595 6 47.6417 0.116275 23.248 13.5287 8.94531 -12.2883 -8596 4 47.0119 0.433387 23.8864 -15.3927 3.59754 12.8324 -8597 4 47.4641 41.0946 23.1357 -2.49679 -12.2922 2.24912 -8598 6 7.90637 37.1762 29.9388 8.54368 22.8184 26.8453 -8599 4 7.85301 37.2098 30.9449 3.45275 -3.37357 -41.2712 -8600 4 8.44496 37.9737 29.6897 -17.0006 -23.7003 10.0801 -8601 6 38.9296 24.2329 12.6383 15.5219 -16.6974 -22.776 -8602 4 37.9787 24.1601 12.7323 -9.9748 0.376678 1.49713 -8603 4 39.1449 23.5705 11.9215 -5.67631 22.059 20.3409 -8604 6 21.3179 26.2613 36.7933 11.7928 19.07 -1.51604 -8605 4 20.8397 25.6962 36.2015 -9.60619 -6.53459 -13.3894 -8606 4 21.5182 25.6957 37.5187 2.0605 -10.1459 21.1123 -8607 6 28.2262 23.3351 24.9913 6.08955 -0.748437 0.460504 -8608 4 28.2308 24.0016 25.6964 4.22655 -6.81745 -1.24962 -8609 4 29.0479 22.8075 25.0363 -13.73 7.51762 2.95505 -8610 6 38.3897 39.5713 14.5774 34.0997 -9.77678 18.0089 -8611 4 38.4779 38.8655 15.2987 -6.58584 29.8461 -29.0755 -8612 4 39.3026 40.0121 14.5422 -41.1029 -19.3921 -1.23505 -8613 6 26.0587 6.01626 38.1331 -7.56489 -16.2073 9.45163 -8614 4 26.364 6.92283 38.0032 14.5247 -0.467326 2.92393 -8615 4 26.7573 5.38712 38.4414 -3.391 26.9876 -7.34507 -8616 6 52.1178 17.2513 22.5128 -10.8492 5.54118 7.42996 -8617 4 52.8997 17.6733 22.1718 9.92427 15.7211 -4.0445 -8618 4 52.2219 16.3395 22.2718 -2.102 -18.0313 -4.16051 -8619 6 39.531 30.2011 31.4754 1.32431 5.33104 20.3977 -8620 4 40.1389 30.6029 32.1578 -26.1612 -12.9519 -10.6425 -8621 4 38.6407 29.9778 31.8528 28.462 12.4065 1.81878 -8622 6 19.6595 6.91666 12.7659 -14.5008 4.80913 14.0157 -8623 4 19.6887 6.47111 13.6446 7.23462 -2.42447 -18.0556 -8624 4 20.266 6.55226 12.115 5.2883 -10.9354 6.21868 -8625 6 32.4266 37.4954 40.1172 13.7501 31.88 -47.4625 -8626 4 32.7425 36.6266 39.9032 -2.48661 -20.9779 5.59445 -8627 4 32.1419 37.5817 40.9958 -11.8933 -10.3197 48.8363 -8628 6 39.7596 0.337115 6.09995 15.1421 -1.66777 24.2876 -8629 4 40.1534 1.22219 6.08152 -5.11901 -0.972083 -7.53812 -8630 4 40.1657 41.8549 6.90018 -9.37436 -2.20237 -11.3555 -8631 6 28.7751 10.1584 29.138 -2.01192 2.80513 -2.93319 -8632 4 27.8238 10.1744 29.001 -3.57801 1.81269 -4.50746 -8633 4 28.8919 9.80572 30.0274 6.34341 -2.0407 -1.56061 -8634 6 28.3442 21.074 10.6333 2.67716 -1.32955 -8.08167 -8635 4 28.7162 21.9756 10.7458 1.68682 -14.6392 -2.70928 -8636 4 28.9848 20.5267 10.1317 -8.30024 16.2649 10.4277 -8637 6 27.0693 28.6863 20.8775 28.7719 -2.37794 4.3254 -8638 4 27.7298 29.2434 21.3283 -4.93173 -3.86203 -1.8773 -8639 4 26.2334 28.9344 21.2444 -24.6691 6.36732 10.1211 -8640 6 39.6873 13.9804 33.4544 10.1398 -5.61125 10.7915 -8641 4 40.0465 13.7022 34.3167 -4.86 2.4669 -10.6871 -8642 4 38.7726 13.6755 33.4723 -5.1401 -2.85022 0.606476 -8643 6 25.4597 11.6576 34.3181 14.491 -28.0098 33.8508 -8644 4 24.8514 11.0162 34.7619 5.36553 12.2612 -15.2396 -8645 4 25.0161 12.1454 33.6493 -21.152 12.7672 -16.4478 -8646 6 27.5131 37.6326 21.427 -19.9573 -21.9997 -23.7283 -8647 4 28.2253 37.2064 20.96 8.67225 -9.05343 -17.242 -8648 4 27.9596 38.068 22.1137 20.557 20.5047 35.0331 -8649 6 30.5914 20.0695 28.6348 27.7431 -17.6396 19.2377 -8650 4 30.9836 19.3645 29.1801 11.8534 20.0629 -12.5158 -8651 4 29.6982 19.8076 28.6872 -39.6618 5.20089 -10.7407 -8652 6 42.3778 1.85684 14.9393 25.4983 -1.50621 30.9456 -8653 4 41.9471 2.41032 15.6124 -5.43016 1.03086 -4.74891 -8654 4 41.8361 1.80616 14.1675 -19.8596 2.00334 -17.6468 -8655 6 12.1616 12.5321 19.523 -14.5305 -6.69845 -4.01711 -8656 4 12.9939 12.0448 19.446 -0.641831 -5.10207 -0.17564 -8657 4 11.4028 11.9007 19.4323 17.6183 8.93718 0.635936 -8658 6 19.2173 1.21358 16.3673 12.2327 1.89672 9.92834 -8659 4 19.755 0.600796 16.911 -5.77615 9.45405 -9.5745 -8660 4 19.8129 1.9499 16.1364 -2.75311 -6.47505 -0.557351 -8661 6 9.48027 16.145 27.6887 18.4383 23.7652 -21.1678 -8662 4 9.95062 16.009 26.8224 -12.6846 -2.19341 25.2173 -8663 4 9.19893 15.3052 28.0262 -3.30777 -17.5687 0.945009 -8664 6 40.4566 26.1709 24.7821 -20.4805 41.2174 -0.532491 -8665 4 40.3628 26.7039 25.5991 10.1463 -19.7663 1.05084 -8666 4 40.0809 26.8306 24.1463 10.2053 -25.1837 1.88999 -8667 6 47.6675 17.6506 18.0225 -30.0634 41.3074 12.2788 -8668 4 48.2543 17.9981 18.7254 0.401995 -10.3127 -9.33209 -8669 4 46.9068 18.3177 18.0388 29.0716 -28.5939 -1.2112 -8670 6 36.6158 25.2629 4.18774 29.3736 28.0527 4.32129 -8671 4 36.5214 25.5758 5.09839 -16.0305 -5.04511 0.138651 -8672 4 37.2819 25.9232 3.86538 -16.6324 -17.2389 -6.3952 -8673 6 39.5728 35.3879 29.6636 12.278 22.7044 -7.26925 -8674 4 39.0499 34.5938 29.661 -5.91236 -8.06683 2.48368 -8675 4 39.3907 35.9006 30.4607 -1.7908 -9.53931 -1.38728 -8676 6 0.412001 14.6096 13.3342 2.26376 -2.5079 -14.7045 -8677 4 54.7802 15.2759 13.6175 -3.32355 6.27336 -0.974202 -8678 4 0.516441 14.0579 14.0961 4.60085 -12.9246 15.0473 -8679 6 12.196 27.3305 8.43326 10.0473 13.6833 14.0535 -8680 4 13.031 26.8669 8.51701 2.31971 -16.5604 -6.51009 -8681 4 12.4357 28.1833 8.85089 -17.0888 -3.60228 -10.1051 -8682 6 36.9057 14.8161 21.1198 30.6025 20.2317 -25.7914 -8683 4 37.0125 14.4244 21.9807 1.92342 -10.2074 20.832 -8684 4 37.7936 15.2053 20.874 -24.9082 -16.5351 5.08732 -8685 6 20.8486 4.94275 21.105 17.9022 -6.61396 -0.309651 -8686 4 20.374 5.67415 21.5228 9.17185 2.06744 3.08402 -8687 4 21.7751 4.88103 21.448 -24.8745 1.45604 -2.42669 -8688 6 36.7441 1.80601 7.63303 -8.86792 14.8212 -18.8361 -8689 4 36.3577 2.71345 7.77493 14.0998 -30.8697 16.0099 -8690 4 36.9898 1.34966 8.45182 -6.21638 14.7491 3.51078 -8691 6 12.2291 31.5076 37.4606 -20.8205 4.71929 16.9336 -8692 4 12.7789 31.2189 36.7301 -1.71439 -5.19212 -6.77065 -8693 4 11.3837 31.0118 37.4916 13.4088 3.21935 -3.86138 -8694 6 38.9875 41.6041 16.8806 -4.97036 -4.86794 -9.64455 -8695 4 39.4307 41.5716 16.0177 3.10466 0.790549 7.7281 -8696 4 39.367 0.410173 17.3903 6.57234 9.13046 2.45051 -8697 6 31.8971 27.2651 22.2536 0.475946 9.95506 -26.8482 -8698 4 31.2288 26.6192 22.5148 1.53167 3.01995 -0.700727 -8699 4 31.6701 27.5469 21.3168 1.33988 -13.0026 32.8364 -8700 6 42.7373 9.18402 25.5752 -16.5205 -8.12573 12.5156 -8701 4 42.0715 8.82875 24.9549 8.97347 3.93682 -3.18445 -8702 4 43.4726 9.55718 25.0966 9.17117 4.66181 -14.1392 -8703 6 50.9317 28.1762 25.3585 1.81467 11.9603 16.0249 -8704 4 50.4332 27.6858 24.699 -7.797 -4.30978 2.61883 -8705 4 50.6061 27.9816 26.259 1.82058 -3.16123 -16.2825 -8706 6 43.2019 19.6758 30.9261 -60.5069 12.608 18.1565 -8707 4 44.1121 19.7947 30.8273 58.227 11.7487 -4.80009 -8708 4 42.8317 20.4979 31.3452 14.2318 -14.5845 -6.94071 -8709 6 30.6579 14.0392 40.8099 -3.90856 28.8453 32.4485 -8710 4 30.2625 14.437 41.6588 6.78025 -22.1962 -33.7862 -8711 4 30.2388 13.192 40.6401 -8.31431 -9.09038 5.19898 -8712 6 20.9126 15.487 23.0255 1.81996 -1.2716 -0.577536 -8713 4 20.3529 16.1851 23.4151 9.86352 -5.06847 -1.26552 -8714 4 21.845 15.6804 23.2451 -11.0139 0.781722 1.09061 -8715 6 34.2266 0.759926 35.8266 5.91607 -35.831 36.3238 -8716 4 34.6699 1.4486 36.3596 -6.19332 -9.6922 -6.67054 -8717 4 34.0788 41.8551 36.4474 5.42693 41.8664 -30.5853 -8718 6 38.9146 36.9114 35.918 21.2173 -10.8751 17.2864 -8719 4 39.7829 37.095 36.338 -12.434 5.66027 -11.9648 -8720 4 38.7157 36.033 36.27 -5.46808 2.11761 -7.10044 -8721 6 45.1412 25.209 22.7799 -9.21588 11.7282 35.1943 -8722 4 44.1635 25.1535 22.9277 18.3683 -4.67801 -8.38153 -8723 4 45.395 24.8019 21.9606 -9.08047 -9.94082 -17.9945 -8724 6 40.6079 0.819632 35.9543 -10.1658 30.0784 -5.29357 -8725 4 40.5743 41.7978 35.9297 8.39322 -37.6139 4.80851 -8726 4 39.8853 1.04128 35.3423 10.5918 6.58535 9.58714 -8727 6 11.0481 28.354 35.0263 -7.05837 2.15472 6.15391 -8728 4 11.0065 27.7661 35.7937 6.20016 -1.50115 -1.31869 -8729 4 10.2774 28.923 35.1598 -2.00076 2.29074 -4.05614 -8730 6 20.214 13.5993 35.8619 28.0429 -16.4719 23.5579 -8731 4 19.4963 13.9327 35.3857 -45.1468 12.1599 -23.9045 -8732 4 20.9404 14.0304 35.4284 21.7873 4.64258 -6.99651 -8733 6 39.6259 5.13927 1.77541 6.3837 10.5905 23.0009 -8734 4 38.815 4.76887 1.43754 -8.89155 -4.8304 -7.9643 -8735 4 40.2998 5.10051 1.09544 5.70124 1.55861 -13.0764 -8736 6 30.2644 30.8765 32.4376 2.45351 13.5189 11.7538 -8737 4 29.6638 31.1848 33.1457 1.37952 -7.29152 -6.97913 -8738 4 29.9065 30.0722 32.0512 -6.5155 -7.29863 -0.0927806 -8739 6 14.5561 10.991 22.8667 10.081 16.7623 43.7388 -8740 4 15.1677 11.6459 23.3133 -13.9792 -18.4015 -26.7579 -8741 4 13.9431 10.829 23.6181 3.59137 -7.6484 -17.8174 -8742 6 20.7554 13.9367 3.0184 -22.7431 -13.2276 -14.851 -8743 4 19.9027 13.7405 2.57467 24.082 -4.954 3.77469 -8744 4 20.4786 14.7044 3.49738 5.42185 19.6619 18.2233 -8745 6 41.2999 4.28373 12.6115 -5.11846 11.2121 16.06 -8746 4 40.5902 3.66826 12.7964 -5.45414 -3.74116 2.1628 -8747 4 41.646 4.04628 11.766 6.8814 -9.70345 -22.8074 -8748 6 10.8486 24.7151 21.7079 -22.0181 20.7635 -2.99902 -8749 4 10.06 25.055 21.1824 26.1755 -20.3138 8.68391 -8750 4 11.196 23.8735 21.3742 -8.74412 -0.217035 -8.2032 -8751 6 53.5851 20.8962 34.3615 -20.5776 4.99959 -7.54911 -8752 4 54.5312 20.9399 34.3174 23.7346 3.60458 -0.717784 -8753 4 53.3344 20.0378 34.731 7.46747 5.54606 -4.26157 -8754 6 14.8822 4.84805 30.4483 -9.71325 -6.00753 -19.6684 -8755 4 14.771 4.94284 29.4789 1.77408 0.90497 14.7496 -8756 4 14.5561 3.94513 30.5986 4.49673 6.24836 5.5759 -8757 6 48.9024 37.1196 13.1149 -36.5603 24.8322 -14.1851 -8758 4 47.9606 37.2057 13.4129 22.1922 -3.12109 -3.19476 -8759 4 49.2987 36.4589 13.6532 13.3268 -16.5999 12.901 -8760 6 26.8059 19.3169 7.54434 -4.26945 -4.42367 7.83904 -8761 4 27.1766 18.4867 7.22339 -3.92405 -4.32352 -1.07463 -8762 4 27.3968 19.9842 7.20607 8.782 12.6164 -5.40832 -8763 6 17.6305 11.9358 39.0864 -20.6439 9.19078 16.9487 -8764 4 18.5077 11.609 39.0209 28.8526 -12.5757 -8.06323 -8765 4 17.5232 12.1203 40.0373 -6.81014 1.23205 -8.73836 -8766 6 49.927 14.591 8.61416 15.5742 -26.1486 -8.96269 -8767 4 49.2009 13.9524 8.72368 2.87529 10.9098 3.94828 -8768 4 49.6414 15.4659 8.85563 -10.1676 20.5637 7.32703 -8769 6 32.3582 34.9735 31.5167 -0.414276 11.4895 24.1707 -8770 4 32.1283 34.3825 30.8126 -1.81559 -4.89127 -12.898 -8771 4 32.4479 35.8663 31.1601 -0.97656 -3.19104 -3.1743 -8772 6 11.821 22.2226 21.3194 1.12988 -20.2292 -31.7924 -8773 4 12.2035 21.6949 20.5593 -17.646 16.3031 19.3587 -8774 4 12.5076 22.1609 21.967 14.4856 1.86701 17.8995 -8775 6 33.8479 9.95925 13.6297 5.85555 4.94861 0.641841 -8776 4 32.9412 9.60258 13.4965 20.4646 2.44791 -13.0803 -8777 4 34.46 9.81143 12.8638 -25.0852 -4.3509 9.75457 -8778 6 25.5216 36.3896 1.4985 -3.83916 -1.90754 -5.44184 -8779 4 26.1733 36.851 0.947779 -3.43756 3.58217 3.68691 -8780 4 24.6678 36.8514 1.38848 10.8858 -3.23471 -1.95008 -8781 6 26.2654 10.5456 9.75524 -44.5011 8.64206 25.1655 -8782 4 25.6084 11.269 9.60979 18.788 -4.56637 -6.88642 -8783 4 25.8198 10.0845 10.5139 21.0346 7.54764 -16.1236 -8784 6 25.0247 0.792222 40.9035 16.6629 9.7536 -9.8108 -8785 4 25.2766 0.410293 40.0414 -7.0744 -0.853038 7.71488 -8786 4 25.4535 1.67289 40.8914 -6.39875 -10.0211 5.33714 -8787 6 46.2514 3.92331 24.811 2.29787 -10.4124 3.565 -8788 4 46.4476 4.07649 23.8793 1.84574 -7.0337 -1.43198 -8789 4 46.0806 2.96577 24.928 -3.00701 8.9366 -8.52535 -8790 6 21.593 13.605 29.211 2.46069 1.87638 12.7155 -8791 4 21.5518 14.2847 29.9136 -0.977025 -6.07097 -8.18011 -8792 4 21.3035 14.062 28.4178 -1.02829 3.62716 -1.29843 -8793 6 36.772 38.3747 0.364057 -13.57 -14.6746 -5.92565 -8794 4 36.4241 39.1227 0.863015 -2.10343 5.30459 -0.282121 -8795 4 36.0255 37.7419 0.250491 13.2024 11.0478 3.68109 -8796 6 19.3024 17.6377 24.0664 34.4056 30.1631 -22.0465 -8797 4 18.4191 17.3498 24.1437 -40.9446 -15.7866 5.54764 -8798 4 19.2946 18.2748 23.3003 0.347271 -14.2409 17.5238 -8799 6 23.1729 12.6936 3.50527 -23.4203 -1.67393 -9.32385 -8800 4 22.2599 12.987 3.28408 10.1497 2.83055 6.60862 -8801 4 23.2366 11.8468 3.05081 2.04707 -0.882582 2.79058 -8802 6 37.8929 8.88926 35.4532 -15.1513 -19.5409 -35.7954 -8803 4 38.8496 8.85033 35.2802 -3.80753 -1.00094 -0.145651 -8804 4 37.4409 8.32345 34.738 24.7998 24.8105 28.8968 -8805 6 14.3214 15.124 36.1936 10.1777 -8.45579 -11.337 -8806 4 15.1189 15.6285 36.3983 0.383997 -0.909139 3.4786 -8807 4 13.728 15.2114 36.9249 -8.84751 6.7001 14.2991 -8808 6 35.0764 0.951221 33.027 4.39995 -0.747562 -23.3066 -8809 4 34.9707 1.92678 33.0471 -0.901583 -14.825 16.9845 -8810 4 34.929 0.489106 33.8671 -4.79444 18.9729 2.67887 -8811 6 50.9368 0.508345 17.9996 -16.1068 -2.11236 -10.8013 -8812 4 50.7363 1.3993 17.6607 6.59543 -7.82408 5.75367 -8813 4 50.2126 41.8571 17.6452 15.113 5.01242 7.08044 -8814 6 26.2276 30.5707 0.943679 2.98972 25.4521 29.679 -8815 4 26.9747 31.0717 1.30878 -11.5718 -5.07384 -0.177367 -8816 4 26.5685 30.1289 0.190254 7.28539 -15.5247 -23.6744 -8817 6 18.5631 38.2963 4.56281 15.0547 -0.00169581 -1.07608 -8818 4 17.6313 38.4808 4.44067 -9.04909 6.52025 -3.84653 -8819 4 19.0145 38.7079 3.79419 -7.75189 -5.39823 9.30868 -8820 6 31.1327 5.08368 4.10816 20.0095 -18.3558 -6.33253 -8821 4 31.8391 4.51927 4.54922 -26.0459 18.0586 -17.7145 -8822 4 31.2112 4.96997 3.12633 -1.20575 2.29654 19.098 -8823 6 26.4386 21.9021 1.48262 11.6176 -12.3641 -2.34526 -8824 4 26.4119 22.77 1.11333 -7.24657 26.8604 -8.21156 -8825 4 27.3591 21.6321 1.37052 -1.3799 -4.61827 0.12427 -8826 6 39.218 11.6975 22.8013 10.5737 17.0434 4.86912 -8827 4 39.8837 11.6898 23.5135 -8.12783 -9.21376 -3.17514 -8828 4 38.7576 10.8611 22.7762 -0.316566 -9.51531 5.7902 -8829 6 13.6104 36.3454 30.6448 12.2201 31.8005 15.4331 -8830 4 13.9411 37.0787 31.1944 -5.64032 -6.12374 -20.8561 -8831 4 13.4819 35.6769 31.3099 -5.82879 -19.5305 -1.97286 -8832 6 50.5737 9.8729 9.34449 -28.5439 -15.8542 -0.594603 -8833 4 49.6941 9.5296 9.68217 24.5077 10.0039 -8.16891 -8834 4 50.7802 10.6382 9.87905 1.56032 8.49656 8.37591 -8835 6 49.6568 40.2957 22.5808 3.13406 -4.17489 -1.45496 -8836 4 49.9643 39.4131 22.2832 -6.04563 10.523 5.74674 -8837 4 49.4657 40.2311 23.537 6.08697 -6.10842 -7.72776 -8838 6 7.19984 41.3227 28.8903 -1.52952 20.6044 28.9443 -8839 4 7.18166 41.5789 29.8666 2.82963 -8.74683 -37.3978 -8840 4 7.33954 0.237732 28.3754 1.09714 -11.2116 9.436 -8841 6 13.0357 18.018 25.3358 19.442 16.9905 44.3108 -8842 4 13.6166 18.1186 24.5548 -1.12298 4.17303 17.3747 -8843 4 13.5323 18.3306 26.2146 -21.9746 -20.4015 -59.5043 -8844 6 50.052 19.589 2.43093 38.9512 -4.48133 -22.8803 -8845 4 50.7424 19.2598 1.79532 -23.4729 1.49397 14.1456 -8846 4 50.5528 20.298 2.8491 -7.87613 8.00017 8.65361 -8847 6 28.349 40.9814 24.5177 14.9096 -9.01222 -0.77751 -8848 4 28.8235 40.5955 23.7606 -4.31864 4.07524 4.80921 -8849 4 27.7156 41.5877 24.1507 -14.6867 11.3415 -7.76415 -8850 6 19.4129 5.36023 29.5381 -15.1481 -17.3665 11.3948 -8851 4 20.1134 5.96028 29.2689 3.1753 8.4576 0.913483 -8852 4 18.7407 5.8353 30.064 8.44892 1.72514 -6.85652 -8853 6 35.3149 40.1584 22.2743 -5.4761 3.67764 -22.0922 -8854 4 35.6772 39.8166 23.0859 3.70556 0.822605 11.3301 -8855 4 35.3088 41.1243 22.2924 6.6179 -0.993945 11.5959 -8856 6 16.1846 33.7767 9.75922 -0.358556 8.53088 17.0233 -8857 4 15.9516 33.2005 9.03859 1.48669 -13.8429 -11.0903 -8858 4 15.6081 34.5411 9.70154 -4.21994 3.45608 -1.0308 -8859 6 17.3638 40.6569 20.2187 0.0478101 13.797 12.0053 -8860 4 17.2553 39.7868 20.6094 -1.96745 -8.64858 -4.42208 -8861 4 17.5346 41.2369 20.9867 0.609446 0.00823871 -10.958 -8862 6 20.5168 9.71855 9.57392 23.3053 8.23996 -15.5036 -8863 4 21.1612 10.0129 10.2371 -5.46071 -1.58749 -5.90152 -8864 4 19.8092 9.36498 10.0856 -20.4585 -11.5711 12.7624 -8865 6 47.4431 20.1927 21.3797 46.3705 -23.5901 12.8176 -8866 4 48.2534 19.5912 21.2825 -32.1103 24.8918 7.30718 -8867 4 46.9863 20.0806 20.5604 -17.463 -0.0836882 -22.1962 -8868 6 38.4119 40.7863 37.8131 4.58972 -16.3007 -8.86139 -8869 4 38.2015 41.716 37.7675 -2.07213 19.1933 -0.538509 -8870 4 38.1163 40.4897 38.6817 -2.89344 0.451293 5.51523 -8871 6 4.78246 1.95264 13.1142 -0.962758 -11.3299 -4.56483 -8872 4 4.86308 1.24617 12.4504 1.09441 11.0888 1.2667 -8873 4 4.58181 1.48453 13.9266 -0.88642 0.622503 9.15822 -8874 6 46.8366 29.0044 2.17213 -21.5573 10.7483 2.0879 -8875 4 46.5703 29.0979 3.11526 14.9241 -10.138 -17.8178 -8876 4 47.6533 28.5191 2.04264 7.39387 -6.09514 13.7966 -8877 6 37.4332 26.1628 25.6457 0.476866 -1.57884 -3.35254 -8878 4 37.1432 25.5044 26.2761 -1.46501 -6.7424 3.65975 -8879 4 36.6379 26.5951 25.3475 -3.92424 6.80267 -0.609098 -8880 6 27.3215 4.19863 19.437 6.03131 -5.89417 1.59018 -8881 4 28.0693 4.5088 18.8685 -19.6633 0.0824503 4.70742 -8882 4 26.4692 4.57526 19.1444 8.48727 3.90116 -6.43998 -8883 6 29.5816 35.1763 32.6702 11.3433 -15.1984 -13.0035 -8884 4 29.498 34.4257 32.0309 -0.34209 19.1564 15.9908 -8885 4 30.487 35.489 32.5363 -2.16348 -1.10322 -0.755163 -8886 6 51.6039 27.3804 34.6228 -16.2846 20.7721 3.47149 -8887 4 51.9118 26.5342 34.8842 8.46829 -31.6815 14.0056 -8888 4 52.043 27.5552 33.7939 4.07896 7.882 -12.2594 -8889 6 26.213 15.718 22.6983 4.45652 -13.2698 4.19624 -8890 4 25.9644 16.5706 22.3629 -2.74203 26.12 0.0562263 -8891 4 25.9462 15.1046 22.0171 -4.99078 -11.3651 -6.14484 -8892 6 36.1284 41.1872 15.4686 -15.9675 5.34592 -0.326298 -8893 4 35.5872 40.4009 15.2728 11.0637 0.363161 -0.898578 -8894 4 37.0593 40.962 15.4319 4.98109 -12.2962 -3.97184 -8895 6 18.4605 8.81439 11.2163 9.85092 25.9028 -2.05591 -8896 4 18.8222 8.21565 11.8732 -2.65799 -9.87079 3.83174 -8897 4 17.6938 8.4288 10.8111 -9.58752 -11.4871 -1.05984 -8898 6 30.2054 21.3176 23.2008 0.0321998 2.06754 0.100272 -8899 4 29.9991 22.2239 22.9456 -2.76699 -3.99559 -1.97847 -8900 4 29.5697 20.7243 22.7648 2.21136 7.68347 0.454199 -8901 6 22.7376 2.20942 34.8415 -7.06988 -25.8748 21.345 -8902 4 22.3263 1.32441 34.7915 6.81547 13.2405 5.99888 -8903 4 22.6443 2.51876 33.959 0.748808 17.6695 -28.972 -8904 6 12.6779 2.74229 12.3423 -3.02369 13.9186 -14.8572 -8905 4 12.6684 3.63953 11.9163 1.20981 -22.4864 12.4813 -8906 4 13.1874 2.20366 11.7175 -0.841633 0.53426 4.77071 -8907 6 24.0891 30.0714 14.5767 2.26717 -13.4561 -11.586 -8908 4 23.8674 30.8343 15.1637 -15.8173 -12.4528 -15.4046 -8909 4 23.3482 29.6562 14.0436 11.1594 27.3113 22.4963 -8910 6 0.0169515 27.9037 22.8558 -22.9231 2.02358 -4.19556 -8911 4 54.5653 28.3586 23.5905 7.88497 -1.22395 1.09473 -8912 4 54.2173 27.7016 22.3138 13.4725 -1.40758 1.11908 -8913 6 12.3768 4.48401 25.8984 -1.01368 1.72138 -1.86924 -8914 4 11.999 5.34556 25.8124 1.61778 23.022 -11.6285 -8915 4 11.6412 4.07623 26.3496 -0.520107 -24.5543 7.98643 -8916 6 50.6552 14.4595 5.90563 -9.7075 2.6569 37.2621 -8917 4 51.421 15.0215 5.71422 1.2699 0.536098 -2.53407 -8918 4 50.4862 14.5526 6.9139 5.60038 -4.97296 -46.1729 -8919 6 52.566 22.8545 20.1304 -1.0263 1.56712 -17.1158 -8920 4 52.8493 23.3468 20.8979 1.30497 -0.175929 17.7779 -8921 4 52.7622 23.494 19.4302 -3.4332 -7.01119 -2.14697 -8922 6 43.5747 16.5432 12.8706 26.1082 -6.15301 -20.1459 -8923 4 44.3581 16.1075 12.4177 -27.2623 16.7463 17.9516 -8924 4 42.8105 16.3628 12.3102 -5.85283 0.59737 -2.51971 -8925 6 15.9643 16.7491 40.5889 4.71604 31.6512 -1.38133 -8926 4 16.4157 17.2981 39.8953 -10.7397 -16.8436 16.4649 -8927 4 15.6568 17.4119 41.253 8.12177 -13.8769 -14.2686 -8928 6 23.4093 18.8548 23.8539 -16.419 -4.21219 2.12821 -8929 4 23.4427 19.3457 24.6888 0.296298 -1.81048 -2.30579 -8930 4 22.5005 18.9913 23.5305 9.65682 -2.29273 2.24785 -8931 6 46.4286 3.27372 31.8783 1.50761 -1.36157 -5.63512 -8932 4 45.559 3.26328 31.468 -2.27736 -0.687336 -10.0334 -8933 4 46.2409 3.35124 32.8099 7.04458 2.11131 4.36323 -8934 6 43.404 41.0501 12.2894 -4.74196 -21.563 6.60959 -8935 4 43.6943 41.7945 12.8025 5.82787 10.392 6.16968 -8936 4 43.4921 41.2918 11.3656 -0.276957 5.00436 -10.4807 -8937 6 7.4944 32.479 29.5886 4.16519 42.7458 -9.72808 -8938 4 8.11522 31.7905 29.7504 15.4265 -22.4366 1.70525 -8939 4 8.06583 33.2868 29.4339 -18.9062 -19.2919 1.43274 -8940 6 4.77786 31.6555 22.5097 8.01353 -0.237295 6.09653 -8941 4 5.36252 32.2279 23.0433 -12.0801 1.27555 -9.50519 -8942 4 4.10079 32.1892 22.0697 5.55495 3.82082 5.5049 -8943 6 48.8707 26.8644 2.67473 3.24755 -50.1854 9.90243 -8944 4 49.7841 26.6767 3.05593 -33.5394 4.93648 -17.7122 -8945 4 48.3402 25.9967 2.74374 27.3415 43.0547 -3.91521 -8946 6 35.3704 23.2724 21.6151 -20.572 -8.60634 18.7236 -8947 4 36.1531 22.7653 21.8467 10.3528 0.763668 -1.9928 -8948 4 35.5272 23.8633 20.8878 14.153 10.3741 -19.8739 -8949 6 9.81162 37.7752 27.3066 -7.93747 -1.88745 -15.4111 -8950 4 9.56608 38.5967 27.7736 11.3364 -13.9943 4.65066 -8951 4 10.53 37.2723 27.7168 -2.00951 8.75096 9.6206 -8952 6 6.95784 10.9804 26.0002 -14.8513 -9.26658 -13.6642 -8953 4 6.43708 10.2284 25.6287 17.7452 16.2397 9.86134 -8954 4 7.32481 10.7062 26.8445 2.87033 -7.35616 11.341 -8955 6 15.9925 34.488 38.9165 -7.91378 13.4212 -4.2482 -8956 4 16.1125 33.5888 38.5756 -0.423195 -0.537141 7.5048 -8957 4 15.8451 34.497 39.8859 4.12272 -10.609 -16.5735 -8958 6 24.136 17.3087 36.1669 -1.30362 -38.1211 0.134245 -8959 4 24.6388 17.5417 36.9612 2.54889 -4.89456 5.81445 -8960 4 24.0565 16.298 36.169 6.29988 31.3296 1.89661 -8961 6 29.9661 19.0481 5.63552 -3.51045 -24.0694 26.081 -8962 4 30.059 18.4844 6.44318 1.40084 7.89656 -22.1005 -8963 4 29.4651 19.7932 5.9612 -6.50009 17.0844 0.645364 -8964 6 41.2323 14.2118 25.8708 0.538972 29.9242 -13.4546 -8965 4 41.1167 15.1135 25.4912 3.21098 -20.1981 4.76589 -8966 4 41.3237 14.3734 26.8138 2.01946 -2.10135 6.77926 -8967 6 30.5977 17.7991 37.3648 -2.09385 13.2702 -7.29075 -8968 4 30.1274 18.3693 36.6865 13.7219 -8.47854 26.2153 -8969 4 30.6897 18.2674 38.2325 -7.09621 1.58925 -18.9017 -8970 6 36.2622 35.7606 28.8616 -21.9344 -15.8478 13.9239 -8971 4 36.666 34.9659 29.2737 0.470987 14.2463 -5.72758 -8972 4 36.9609 36.34 28.5862 17.8584 7.52692 -3.58957 -8973 6 0.186361 37.881 20.3783 -19.4052 1.06805 -13.5296 -8974 4 0.625244 37.258 20.9754 1.43275 1.23053 -1.08677 -8975 4 54.3963 37.4077 20.0073 13.2242 8.68111 6.51083 -8976 6 49.5157 39.5849 25.2719 1.34086 -27.0873 28.6785 -8977 4 49.1738 39.8396 26.1677 9.83442 -4.23573 -27.15 -8978 4 49.8309 38.6394 25.3482 -11.1501 31.2987 0.525887 -8979 6 21.6501 10.2052 29.3652 1.38747 -32.8599 -17.8213 -8980 4 21.4815 11.1062 29.1158 -2.57329 19.5966 11.1399 -8981 4 21.7962 10.0736 30.3036 1.32123 13.0863 10.38 -8982 6 36.4484 30.062 0.133613 20.0221 49.2239 1.07318 -8983 4 36.3691 29.4748 41.3122 -8.72629 -28.1564 -18.1683 -8984 4 36.9877 30.812 41.6437 -16.8233 -22.5363 23.3328 -8985 6 35.2366 23.3806 39.1473 20.2218 -67.2813 -35.6269 -8986 4 34.8925 23.3776 38.2436 -2.85003 -5.00903 7.3464 -8987 4 34.9678 24.1769 39.4749 -24.7984 75.1446 29.9953 -8988 6 25.4958 17.6356 38.7131 -1.05403 5.23051 -13.5311 -8989 4 26.2557 17.1099 38.9745 11.6052 -6.82876 2.03202 -8990 4 25.6896 18.4914 39.1039 0.551448 5.55093 4.31103 -8991 6 32.6851 1.71412 15.3757 -17.1832 -26.0249 32.2484 -8992 4 32.9133 1.90091 16.3255 -0.281287 1.06348 -22.8896 -8993 4 32.1369 0.878474 15.451 14.5551 28.5253 -7.92953 -8994 6 2.74577 26.2334 40.164 -3.83079 -17.2464 -24.8373 -8995 4 2.52975 26.8073 40.8689 -10.0885 25.811 23.4985 -8996 4 3.46379 25.6906 40.4857 13.7859 -11.3271 -3.22577 -8997 6 25.4247 39.5803 6.65235 -3.20662 25.1889 -29.4644 -8998 4 26.0108 39.0547 7.19361 -10.0861 -10.9475 13.3666 -8999 4 24.4797 39.508 6.87242 11.3389 -11.2764 10.0712 -9000 6 3.89558 2.45526 21.1915 20.3615 -74.5786 -16.468 -9001 4 3.45835 1.54866 20.9342 19.9424 46.4596 11.9477 -9002 4 3.20863 3.06758 21.3193 -35.5841 29.5388 2.2294 -9003 6 19.428 35.9937 6.17834 -35.0483 8.79483 10.2733 -9004 4 18.6638 35.8781 6.77432 14.6839 -5.07873 0.0324743 -9005 4 19.0495 36.6291 5.56439 9.71061 8.85688 -10.7695 -9006 6 53.6717 10.8593 34.7958 -7.0633 -31.3632 -8.45381 -9007 4 53.6341 10.4895 35.6991 7.39736 18.8685 -12.2464 -9008 4 53.8829 11.7827 34.7263 4.03482 19.5096 16.0301 -9009 6 51.2684 14.0949 34.672 -8.65676 -1.63762 -26.9588 -9010 4 50.7715 13.5641 33.9816 13.3581 12.906 22.4054 -9011 4 51.0369 13.7812 35.5532 -5.90867 -9.66849 3.74112 -9012 6 14.4369 40.0234 28.032 -17.7583 12.3896 33.8878 -9013 4 13.8707 39.2432 27.9284 6.73847 -3.79593 -5.43806 -9014 4 14.0697 40.4885 28.8439 14.5888 -10.3946 -25.5694 -9015 6 36.0586 40.8581 1.30985 34.3129 5.11816 -1.28261 -9016 4 35.3876 41.022 1.96214 -5.4524 5.11716 12.4526 -9017 4 36.8901 41.3246 1.61712 -30.5352 -10.0787 -2.88322 -9018 6 32.5955 21.8673 9.61487 11.2903 3.47268 22.8686 -9019 4 32.2562 21.1899 9.03409 -3.19899 -6.31213 -16.1683 -9020 4 32.8032 22.6511 9.09762 -2.66985 0.307575 -11.8305 -9021 6 53.7554 11.4583 10.0657 12.5408 -15.0223 -21.3323 -9022 4 54.7025 11.5478 10.261 -4.15933 2.55001 3.12883 -9023 4 53.7605 10.7769 9.36125 -9.51558 7.63224 9.70748 -9024 6 25.4365 2.06658 35.0039 -16.8474 18.4627 -14.151 -9025 4 25.5892 2.94197 34.5728 -1.09755 -16.5277 9.12484 -9026 4 24.4603 2.05675 35.1439 15.8828 -2.54758 -2.86629 -9027 6 38.4258 16.3759 27.0837 10.3035 -3.82582 33.4754 -9028 4 38.4229 16.0362 28.0039 4.2105 -6.34073 -14.2668 -9029 4 38.1536 17.2766 27.2341 -1.96409 14.1736 -9.55492 -9030 6 11.9898 11.8134 38.076 -13.826 -2.82892 7.4824 -9031 4 12.2944 12.4411 38.7385 15.2198 2.85174 -2.31876 -9032 4 11.0532 11.721 38.3132 2.05768 -5.32701 -10.6008 -9033 6 21.1746 40.7334 25.8979 40.4357 -13.6237 -24.6728 -9034 4 20.6698 41.4315 25.4918 -16.6357 14.348 -0.996217 -9035 4 20.789 40.494 26.7242 -19.3448 -1.94923 24.9485 -9036 6 5.46053 31.2633 28.1043 10.2831 7.82506 0.3012 -9037 4 4.85681 31.7249 27.5011 4.53193 2.9664 -2.03256 -9038 4 6.18919 31.875 28.3487 -9.19227 -4.78386 -2.03476 -9039 6 38.5722 10.4288 26.6273 1.75688 -6.42268 2.69181 -9040 4 39.2722 10.957 26.2192 0.13713 -2.38088 1.965 -9041 4 38.9883 9.93745 27.351 -0.726559 6.62326 -4.692 -9042 6 34.5654 22.2334 5.77474 -10.6824 6.04198 20.2303 -9043 4 33.6505 22.4646 6.03122 6.34024 -5.77168 -8.80249 -9044 4 35.1097 22.5906 6.49609 1.67963 -6.25138 -9.01327 -9045 6 19.5088 23.4111 8.91157 10.1707 -16.3121 14.7533 -9046 4 19.7449 23.1021 9.7973 -5.16612 6.6008 -0.0119594 -9047 4 19.9964 22.8054 8.35541 -0.106246 2.40248 -11.9056 -9048 6 19.7526 39.1673 18.9392 3.41392 2.41259 -7.44399 -9049 4 20.3112 38.9942 19.7162 -9.66179 4.90282 -1.08801 -9050 4 18.9888 39.695 19.2431 8.6955 -6.10904 -0.220035 -9051 6 19.0066 16.6479 37.8897 24.9266 -16.0788 2.00499 -9052 4 18.1904 16.5622 37.4269 -20.8911 -0.0800444 -12.5516 -9053 4 18.858 17.3198 38.5387 -2.83386 13.0664 11.2213 -9054 6 46.1457 18.3015 34.4662 -13.7163 3.02283 10.6817 -9055 4 46.1788 17.7584 33.6837 2.50627 -7.36872 -12.652 -9056 4 45.2295 18.6352 34.4793 7.83367 -3.11582 0.242547 -9057 6 37.6724 4.92727 10.6572 20.6306 -0.498941 -29.5329 -9058 4 38.5268 5.23995 10.2493 -20.9001 -6.48587 16.5696 -9059 4 37.1025 4.69637 9.88262 10.9132 7.05613 26.3995 -9060 6 51.9879 36.0003 6.84307 -0.0349375 1.28893 10.7684 -9061 4 52.0937 36.793 6.30051 2.19835 -5.62517 4.5242 -9062 4 52.7425 36.0295 7.48232 -7.26034 2.01661 -20.7899 -9063 6 26.6747 12.3215 0.993928 -15.5873 -26.456 -19.7503 -9064 4 26.4829 12.3908 1.92985 -0.4811 3.80705 11.7504 -9065 4 26.1241 11.5295 0.732228 15.7893 19.669 4.48242 -9066 6 51.344 35.7707 13.5244 -1.45768 15.8539 -2.86245 -9067 4 51.4515 36.3837 12.7824 1.55721 2.40741 1.90229 -9068 4 51.4783 34.9191 13.1366 6.57206 -21.9808 -6.55402 -9069 6 1.98876 3.63996 24.5779 3.53339 50.093 -23.5227 -9070 4 1.66274 3.05681 25.2088 -14.7773 -39.8355 33.4132 -9071 4 1.68527 4.50485 24.9411 8.95614 -12.6616 -11.2736 -9072 6 33.5242 15.2767 16.4494 0.0755523 4.59339 -41.038 -9073 4 33.5553 15.5138 15.4787 -3.36737 -9.15609 28.4742 -9074 4 33.81 16.089 16.8707 2.78154 5.67933 12.8052 -9075 6 10.7376 26.5972 37.3568 -53.543 46.6204 -3.13137 -9076 4 10.2745 27.0143 38.1249 4.48347 -4.84659 -12.5134 -9077 4 11.4659 26.2171 37.7527 59.8403 -33.1666 26.4091 -9078 6 39.618 8.36935 32.0025 -18.1555 9.41152 20.5333 -9079 4 39.1948 8.91554 32.6893 14.8148 -9.04413 -3.7523 -9080 4 39.059 8.55692 31.2545 -3.75745 -0.899113 -17.0741 -9081 6 48.8678 24.2325 11.5968 8.56011 -30.9839 -7.0275 -9082 4 49.2355 23.3258 11.4382 -10.5357 21.2684 5.64902 -9083 4 49.6052 24.6956 12.0119 -1.11745 3.30341 0.0123828 -9084 6 15.7966 8.52145 22.5402 1.04041 9.04678 1.57429 -9085 4 15.9271 8.56462 21.5825 -0.708828 -3.15413 5.43528 -9086 4 15.5351 9.42629 22.7739 -0.982858 -3.13072 -0.606507 -9087 6 16.9647 23.5461 7.94634 -33.4976 4.63454 -7.56842 -9088 4 17.0449 23.8842 7.03772 17.2153 -3.19264 11.7182 -9089 4 17.7681 23.4723 8.45101 25.4501 5.7081 -7.03081 -9090 6 42.4788 26.856 6.32162 3.09129 16.6976 -8.96027 -9091 4 41.8509 27.5547 6.55233 4.05081 -5.7053 1.31186 -9092 4 43.1337 27.3683 5.79469 -5.76138 -9.42264 4.17624 -9093 6 36.7899 4.80361 30.039 -6.11534 9.52442 2.68488 -9094 4 37.0233 4.89717 30.9689 4.03122 4.23205 -0.240484 -9095 4 36.2783 4.00567 29.9694 -7.15291 -10.8132 -0.980928 -9096 6 45.6188 11.6101 3.31184 17.0103 13.4398 12.4748 -9097 4 45.8378 10.6807 3.43524 1.11174 -8.0511 2.33471 -9098 4 46.2756 12.0957 3.86714 -12.3909 -9.3108 -12.4209 -9099 6 24.8953 36.3829 21.2888 -10.2051 -4.79955 -3.81503 -9100 4 24.4947 36.4635 22.1668 10.8854 5.06826 1.45383 -9101 4 25.816 36.6689 21.3407 0.621807 2.11968 6.76072 -9102 6 31.8152 24.7333 2.44905 16.2387 18.0677 -0.666362 -9103 4 31.5926 23.846 2.71622 -2.49338 -12.6998 4.18613 -9104 4 32.794 24.7683 2.43834 -16.3068 -2.39725 -1.0987 -9105 6 24.1315 21.9864 37.2328 -11.9778 41.7246 15.7453 -9106 4 24.1531 22.9879 37.1682 1.73438 -35.6656 2.36813 -9107 4 24.6319 21.6756 36.4808 8.45953 -1.72708 -12.6617 -9108 6 37.1993 11.5451 15.0492 16.5469 7.10484 -0.527568 -9109 4 37.9299 11.7412 15.6355 19.6925 -10.3737 -3.43176 -9110 4 36.5282 11.9944 15.5291 -36.4248 10.8574 4.75341 -9111 6 36.4804 20.3298 41.7865 -14.7619 -38.0306 11.4639 -9112 4 36.2972 19.4996 41.306 -2.7681 3.32899 7.9346 -9113 4 36.9128 20.8369 41.1399 19.1888 26.5648 -23.5244 -9114 6 32.0378 37.9251 32.6621 -20.5074 -27.3147 -8.21436 -9115 4 32.5159 38.6908 32.9558 4.48721 20.2349 -0.22713 -9116 4 31.3298 38.1855 32.0457 8.6638 5.37323 8.26506 -9117 6 12.0353 39.9275 22.5179 -19.9222 21.97 13.043 -9118 4 12.3148 40.8142 22.1582 -9.65836 -22.9721 12.3921 -9119 4 11.2968 40.0749 23.1753 26.4497 -1.81786 -22.4595 -9120 6 26.3421 1.33641 19.2861 18.8224 -12.0939 15.9617 -9121 4 26.8564 0.711595 19.8557 -14.3211 16.2919 -14.6989 -9122 4 26.7977 2.18849 19.3545 -2.53714 -0.144297 -3.51109 -9123 6 5.91333 14.3058 5.68279 5.58536 -17.6781 -26.1831 -9124 4 6.35226 14.1008 4.80839 -10.2521 5.5819 21.3359 -9125 4 5.1498 13.7016 5.72209 7.95548 1.62414 0.442017 -9126 6 13.3681 23.0924 19.1542 -7.87238 10.4677 13.234 -9127 4 14.1204 22.8148 18.6592 15.6827 -8.39443 -13.4152 -9128 4 13.7622 23.5769 19.9007 -5.90355 -3.89356 -3.96922 -9129 6 23.3981 15.0775 9.7431 -16.2896 3.15659 0.0853289 -9130 4 22.5416 14.6758 9.94236 4.38356 -3.66538 1.71341 -9131 4 23.1926 15.7004 9.03099 5.43777 4.93098 -2.67512 -9132 6 49.5886 13.8369 18.4468 -1.57371 0.160736 10.1606 -9133 4 48.8725 13.4353 17.9701 -17.3578 -11.6866 0.338485 -9134 4 50.0711 14.2256 17.7358 20.2332 17.1818 -14.445 -9135 6 41.7455 5.66741 41.8995 19.0031 1.14603 7.86728 -9136 4 42.5946 5.93333 0.438032 -19.5636 -6.95293 -12.6597 -9137 4 41.9891 5.05837 41.1762 -2.65724 5.24908 4.18535 -9138 6 17.2511 35.5417 2.55548 5.2045 0.397579 1.12894 -9139 4 18.2067 35.619 2.48098 6.39755 9.05508 3.07921 -9140 4 17.0886 34.6316 2.34229 -4.27489 -11.2961 -3.02567 -9141 6 49.7041 19.8589 40.2412 43.8428 -27.8149 3.09893 -9142 4 49.318 19.0163 40.5437 -5.31641 8.5833 -2.14336 -9143 4 50.6864 19.6533 40.2493 -27.6084 12.6334 -3.24012 -9144 6 38.3071 5.82731 32.0534 -20.9946 -3.84451 12.3853 -9145 4 37.8352 6.48986 32.6009 6.6943 -7.79079 -6.23381 -9146 4 39.2094 6.1245 32.003 13.4939 6.60324 0.292563 -9147 6 16.2694 6.84865 34.0054 -5.49782 1.82896 8.85162 -9148 4 16.5828 6.71308 33.1028 9.77351 -3.29618 -0.21352 -9149 4 16.9894 6.61948 34.6288 -2.86373 0.259786 -9.19674 -9150 6 33.6805 18.2019 10.4544 40.2358 -26.4835 -11.4715 -9151 4 34.2537 18.8203 9.96489 -9.74865 -7.15313 7.53482 -9152 4 34.2179 17.3378 10.5117 -27.819 38.8859 -1.78852 -9153 6 38.8962 33.7675 36.7566 23.6769 3.34821 -39.6603 -9154 4 38.383 33.5793 35.9171 9.63189 4.7017 21.543 -9155 4 39.855 33.8637 36.4612 -29.1237 -5.01255 9.39617 -9156 6 45.367 13.0954 20.2202 -17.4715 7.54819 27.7127 -9157 4 45.262 12.6289 19.4029 4.78427 -8.6457 -19.3619 -9158 4 44.4728 13.0498 20.6095 8.33403 2.77458 -3.46579 -9159 6 36.394 32.2025 8.83838 -5.39961 -0.779561 10.8196 -9160 4 36.3766 31.4559 9.45045 4.37642 -0.919546 -0.394048 -9161 4 35.9671 32.9207 9.33542 2.20851 -0.984819 -7.57369 -9162 6 7.93081 27.8143 6.16526 -1.31132 8.47671 -18.7581 -9163 4 8.2701 27.2941 6.88743 5.87236 -5.84072 6.56369 -9164 4 8.18271 28.7096 6.41539 -7.71007 1.94397 -1.55613 -9165 6 14.2797 4.87717 33.6823 -38.1616 11.9775 -32.0892 -9166 4 13.6477 5.2447 32.9846 23.9092 -16.4836 27.177 -9167 4 14.8408 5.63056 33.8658 12.4601 7.15131 6.13949 -9168 6 12.2578 8.65243 9.85848 -4.82715 -2.24662 -5.48477 -9169 4 12.6456 8.73928 10.7118 23.7259 9.48722 19.5525 -9170 4 11.4378 8.2214 10.089 -13.622 -8.47682 -13.9839 -9171 6 29.7261 31.9842 8.54243 -17.2145 25.3825 -18.7463 -9172 4 30.1804 31.833 9.34913 11.7892 -12.8324 21.9258 -9173 4 29.6399 31.1708 8.03663 5.85846 -6.51984 4.51241 -9174 6 22.3891 10.8785 21.4662 8.73739 -5.18702 6.55753 -9175 4 21.8037 11.1386 20.7714 -14.2177 0.338512 -24.4291 -9176 4 22.2091 11.5521 22.1168 2.36988 5.22793 14.1218 -9177 6 54.1797 27.5396 12.9955 26.3988 -18.3584 17.6139 -9178 4 0.160041 27.5787 13.0909 -6.71045 -5.06664 4.99497 -9179 4 53.9798 28.2721 12.4475 -15.7222 27.4826 -22.0497 -9180 6 7.71973 13.812 20.0407 -34.9077 17.0186 -30.9147 -9181 4 8.32362 14.1503 20.6766 20.1403 8.526 22.156 -9182 4 7.35968 14.6399 19.6101 8.73645 -26.5601 8.16532 -9183 6 19.7932 0.841243 24.7869 -1.21084 18.2021 12.2367 -9184 4 19.1669 1.06895 25.5104 7.86649 -0.445713 -11.3386 -9185 4 20.4073 1.61074 24.7031 -15.4775 -18.2332 3.4978 -9186 6 3.01312 10.0986 2.94829 -27.2997 12.089 -8.88269 -9187 4 2.52802 10.9508 2.83041 12.1807 -20.5661 3.67701 -9188 4 3.91304 10.3154 3.17839 17.025 6.36995 4.07131 -9189 6 15.8857 13.0124 24.0049 15.5529 -4.67501 -5.43243 -9190 4 15.0856 13.5308 24.0834 -5.13718 6.9751 3.63726 -9191 4 16.3233 13.139 24.8614 0.105722 -2.17465 -3.852 -9192 6 17.0852 4.33969 26.9167 21.5143 -4.09641 1.48348 -9193 4 16.9912 4.27513 25.9666 -0.355278 1.74978 -10.9716 -9194 4 18.0601 4.31538 27.0472 -16.9044 3.21714 1.83131 -9195 6 33.6168 39.4091 10.6433 -2.74936 14.5855 -32.8438 -9196 4 33.9454 38.5625 10.8616 8.60753 -33.4012 17.9817 -9197 4 33.8375 39.4354 9.68976 -8.01757 16.2593 11.171 -9198 6 36.2326 1.10755 13.0941 -10.1125 -3.31802 -5.56412 -9199 4 35.6506 0.392496 13.3579 -10.7819 -8.26966 -9.36682 -9200 4 36.7599 1.20112 13.8707 17.1874 9.72194 12.3054 -9201 6 40.862 19.2925 5.11158 -0.402197 -15.9333 44.5432 -9202 4 40.3871 19.4968 4.34679 -15.032 12.6888 -52.1674 -9203 4 40.1189 19.1611 5.72143 13.4548 0.976419 10.4775 -9204 6 2.35452 37.5497 10.1778 32.5589 0.132829 19.8916 -9205 4 3.04634 37.0953 10.7141 -10.4583 9.64478 -9.40166 -9206 4 1.85979 36.8581 9.75685 -15.4906 -16.9123 -13.0897 -9207 6 8.10293 29.0334 15.8847 29.3895 -23.7333 0.542295 -9208 4 9.03551 28.6824 15.7668 -29.6945 17.5799 0.572456 -9209 4 8.18484 29.8326 16.4072 3.85606 5.10463 3.42896 -9210 6 47.3132 26.514 12.5427 4.56821 28.1849 -37.0073 -9211 4 47.5111 27.2634 11.8891 -8.56493 -28.9528 31.2783 -9212 4 47.3519 25.7475 11.9556 -1.34676 -3.33794 4.54904 -9213 6 33.5886 17.4994 0.666432 -7.15301 -2.01744 8.51284 -9214 4 32.6196 17.5968 0.930917 31.8637 -19.8727 -7.43903 -9215 4 33.9404 16.5735 0.747207 -21.2256 15.6146 2.50609 -9216 6 38.9757 15.6004 36.3686 4.31005 -11.6982 -11.4703 -9217 4 39.1719 14.652 36.4294 -3.02079 4.3409 1.02949 -9218 4 39.3764 15.8813 35.5317 -1.53099 5.14915 -0.246696 -9219 6 34.8198 34.351 9.37266 2.46578 -22.7668 -16.8875 -9220 4 35.3506 35.0289 8.96724 14.9634 11.0695 -15.2613 -9221 4 34.4558 34.8191 10.0913 -19.5236 18.4179 34.8179 -9222 6 44.9681 2.58102 14.7874 21.8703 21.498 2.75759 -9223 4 44.0383 2.44896 14.9383 -16.9502 -5.72583 1.77575 -9224 4 45.1679 3.47323 15.1264 -3.49788 -5.23458 -3.46791 -9225 6 42.6138 38.2902 19.8325 18.6047 12.1973 -29.2276 -9226 4 42.7029 39.1598 19.3445 -0.0117609 -27.8329 13.7468 -9227 4 43.0921 37.6383 19.2425 -13.1736 20.1758 17.0781 -9228 6 18.6869 26.7647 30.2619 -33.6624 -6.012 -17.6355 -9229 4 18.1258 26.7596 29.445 14.3051 -0.674317 21.614 -9230 4 19.5687 26.9499 29.9621 19.5047 4.84041 -5.57389 -9231 6 38.8661 37.7421 16.4836 -9.78438 -6.51051 7.80135 -9232 4 38.7478 36.8102 16.2377 -7.01003 6.44463 1.75037 -9233 4 39.8105 37.8446 16.5724 18.1337 5.4462 2.51551 -9234 6 49.3017 9.82081 12.5377 12.9664 18.8416 30.0962 -9235 4 48.8085 9.39111 11.8826 -17.6666 -23.7062 -38.8329 -9236 4 48.5984 10.2345 13.0427 4.42646 9.01279 7.79627 -9237 6 43.2246 7.36268 19.8264 -1.99344 11.167 24.993 -9238 4 42.5572 7.81175 20.4051 12.7818 -10.9207 -14.0727 -9239 4 44.1025 7.51179 20.2375 -5.96789 -3.6213 -7.06723 -9240 6 36.3461 38.714 4.42821 -2.77728 9.11116 8.98737 -9241 4 36.8002 39.5234 4.70824 5.05063 -6.10698 -1.49424 -9242 4 35.4394 38.9016 4.68929 -3.84434 -7.68842 -3.54296 -9243 6 27.8 17.802 15.105 0.992317 -7.44098 -8.78046 -9244 4 27.5393 16.935 14.729 3.58787 16.6938 2.50389 -9245 4 27.8517 17.6781 16.0585 0.147204 -0.130556 3.13955 -9246 6 18.0837 3.77506 37.3201 -10.3169 -12.5791 -10.2966 -9247 4 18.6663 3.07474 37.0146 -2.03685 -5.25132 -4.70316 -9248 4 18.6637 4.19691 37.9324 10.4473 20.1285 21.3871 -9249 6 7.71395 11.575 6.52222 6.59834 -21.2687 20.1659 -9250 4 7.75955 12.4254 6.93969 -0.705235 13.257 9.50392 -9251 4 7.66936 11.739 5.5978 -3.42683 1.36071 -31.338 -9252 6 31.4909 14.3449 18.0451 -1.46982 -12.276 17.176 -9253 4 32.1287 14.6507 17.397 7.38292 5.65775 -7.44504 -9254 4 32.0331 13.8785 18.7146 -6.90734 4.25576 -5.30331 -9255 6 50.3346 30.4143 8.91505 10.1635 2.25064 -1.90936 -9256 4 49.6557 30.853 8.39615 -4.47176 4.28708 -1.87566 -9257 4 50.0231 29.531 9.11356 -2.73977 -1.84009 2.34474 -9258 6 42.1686 10.1057 12.759 16.2008 2.03437 -4.20809 -9259 4 41.2649 9.83209 12.6487 -17.4225 -8.81494 -4.74081 -9260 4 42.1292 10.8861 13.3105 -1.28453 5.18814 5.66853 -9261 6 37.773 3.09539 32.5582 -5.24906 4.78867 -2.39206 -9262 4 38.0736 3.99724 32.5969 21.7942 11.3719 -4.3192 -9263 4 36.8519 3.25822 32.7463 -19.4678 -11.9252 3.55114 -9264 6 35.7586 13.1005 19.2721 9.99017 -22.7528 0.0781354 -9265 4 36.1308 13.8223 19.7887 2.26592 2.2719 5.61144 -9266 4 36.2509 12.2915 19.5517 -9.66412 15.3645 -2.5809 -9267 6 45.5318 4.12684 21.4944 7.1153 -16.224 0.922187 -9268 4 45.5588 4.23252 20.5315 -1.8039 6.94223 3.67507 -9269 4 45.7548 3.18328 21.6122 -5.15542 13.2346 -0.821742 -9270 6 16.876 1.8608 31.4782 -3.84426 -17.9183 -35.0426 -9271 4 16.0621 2.17388 31.0004 15.6258 0.929179 27.3362 -9272 4 17.1381 2.25043 32.3174 -12.6393 14.1325 4.42374 -9273 6 14.0947 4.88307 23.5769 -10.6061 -28.6131 16.0669 -9274 4 13.8059 5.76888 23.7237 -2.25817 32.588 -6.82267 -9275 4 13.6039 4.42137 24.2892 9.04813 -2.88937 -11.9208 -9276 6 38.3208 33.7635 12.3625 -16.3318 -7.70706 -26.0192 -9277 4 38.1373 32.9408 11.8506 0.297782 14.7405 12.2413 -9278 4 39.1486 33.6221 12.8093 16.0136 -1.39994 11.7584 -9279 6 35.6849 3.05753 37.6719 3.72695 1.1389 -16.7638 -9280 4 35.1101 2.5063 38.212 -4.0587 0.687226 6.19097 -9281 4 35.8854 3.87289 38.1447 -1.86413 5.08658 8.8135 -9282 6 31.3385 37.395 35.3723 -12.2239 -8.91609 34.0312 -9283 4 32.2231 37.7249 35.5382 9.93962 6.70229 -3.55138 -9284 4 31.225 37.4524 34.4409 4.86335 0.993516 -31.3389 -9285 6 52.0614 11.7324 14.0182 20.1458 -4.7001 -39.6215 -9286 4 52.0268 11.0667 13.2735 0.495691 14.4049 24.809 -9287 4 52.7095 12.4171 13.7023 -24.8081 -17.2766 13.6147 -9288 6 26.3478 3.42613 41.0189 1.80794 1.58056 -19.374 -9289 4 25.6151 4.01507 40.9203 -25.7718 5.99951 16.8165 -9290 4 26.7914 3.68675 40.2055 22.5797 -12.3384 -0.204994 -9291 6 24.3802 34.9453 11.1613 28.8325 38.7039 -6.19962 -9292 4 24.3515 34.6784 12.0652 -4.50215 -14.1529 28.2178 -9293 4 23.9023 34.3202 10.6558 -20.492 -31.6724 -14.1682 -9294 6 32.0094 7.59293 31.2147 -3.26399 8.81733 5.62682 -9295 4 32.0976 7.47613 30.2777 2.1706 -0.778595 -17.1478 -9296 4 31.5266 8.43606 31.2858 0.565291 -7.84955 4.65821 -9297 6 28.7282 2.60805 0.424377 -15.1279 1.50585 -5.39222 -9298 4 29.2952 2.36387 41.5859 -5.33248 3.35197 5.42737 -9299 4 27.7901 2.65331 0.119401 23.4632 0.0509354 2.06419 -9300 6 42.125 19.2126 9.86039 10.7783 -7.26578 33.4177 -9301 4 42.6695 19.2101 10.7019 -20.1092 0.869002 -30.5597 -9302 4 41.4363 18.5278 9.96356 3.48727 6.10561 -4.25932 -9303 6 33.0194 27.0842 8.32851 16.6372 -6.55357 -10.7525 -9304 4 33.8911 27.0001 7.90493 -7.38323 -0.765342 -2.5624 -9305 4 33.2437 27.3744 9.20899 -0.425855 7.33259 11.2137 -9306 6 4.16433 8.30018 19.1575 16.0783 -2.51395 5.95143 -9307 4 4.71165 7.98099 18.3991 -19.3854 5.29846 8.38252 -9308 4 3.22273 8.32359 18.9288 3.05712 -5.28108 -12.2975 -9309 6 20.7745 29.1912 37.0609 -25.9123 -20.3491 -5.83769 -9310 4 21.0713 28.277 37.0594 -15.1664 -12.7508 0.5123 -9311 4 21.6013 29.5933 37.1743 32.957 35.4267 8.73191 -9312 6 13.1089 4.99809 10.9103 2.80775 13.1965 -7.17841 -9313 4 13.4591 5.85092 11.2415 -2.5949 -14.1267 -1.88178 -9314 4 12.7051 5.16456 10.0462 -1.2434 3.82389 2.90473 -9315 6 37.5087 18.1031 32.5343 20.0502 31.699 14.1692 -9316 4 38.1018 18.8164 32.1735 -18.2411 -21.7333 4.56216 -9317 4 37.2041 18.4813 33.3903 1.90105 -7.17599 -12.7275 -9318 6 17.7655 33.2839 30.7231 12.9967 19.9173 -17.9311 -9319 4 17.8488 34.0437 30.1253 -3.68331 -4.50715 1.49576 -9320 4 18.5638 33.345 31.2563 4.57995 -0.934488 4.72964 -9321 6 23.1969 32.7832 9.90135 2.14033 10.4984 -5.43395 -9322 4 23.4737 31.9362 10.2634 3.28964 -4.66398 1.33779 -9323 4 22.2469 32.7196 9.72631 0.753558 0.42269 -0.434072 -9324 6 14.8911 9.35828 34.246 -8.54616 0.784134 0.501674 -9325 4 15.4672 8.59016 34.1372 5.2294 -0.0873347 -3.8795 -9326 4 15.23 10.0905 33.7027 2.53244 -1.05206 0.202563 -9327 6 31.1203 39.3599 38.5719 4.30147 -17.578 8.21172 -9328 4 31.5941 38.6377 39.0527 -10.1026 17.4492 -9.05875 -9329 4 30.4019 38.9077 38.1077 1.84332 2.82409 1.03593 -9330 6 5.29005 34.4279 28.2716 -0.764315 -10.945 -9.90403 -9331 4 5.24266 35.3772 28.447 -0.427568 -2.02335 -2.15628 -9332 4 5.18384 34.3192 27.3143 2.05225 4.04935 9.99949 -9333 6 30.3216 21.6974 14.1256 3.24994 1.03129 -0.468005 -9334 4 30.4656 20.7696 14.235 0.884625 -14.9253 16.053 -9335 4 30.3519 21.7638 13.1772 -0.963709 16.3006 -15.7103 -9336 6 23.8542 39.0018 28.2919 38.6077 23.8437 -8.99828 -9337 4 23.8505 39.6937 27.6143 9.44649 3.56781 3.51793 -9338 4 23.0185 38.6309 28.1896 -50.029 -28.3524 0.952356 -9339 6 9.61332 13.5451 16.4567 13.7131 10.5156 -25.323 -9340 4 8.77595 13.0917 16.3907 -9.93448 -5.52821 8.41851 -9341 4 9.74204 13.8378 15.5322 5.69689 -3.544 12.5309 -9342 6 25.9753 6.18174 15.7989 23.4837 -9.67411 23.9067 -9343 4 26.0218 6.10484 14.8454 5.11216 -1.95092 -7.71856 -9344 4 26.7445 5.66727 16.1761 -27.6477 18.1551 -17.3833 -9345 6 15.9921 33.6419 22.5616 2.25497 8.86036 -26.9911 -9346 4 16.0049 34.0594 21.6804 -4.22455 0.568633 15.0409 -9347 4 16.1032 32.7157 22.281 -1.05219 8.42244 16.6761 -9348 6 40.6812 13.5416 12.1266 -4.5396 -12.3661 6.74099 -9349 4 40.4134 12.947 11.4149 -4.75912 -2.4644 -8.17888 -9350 4 41.058 12.9332 12.7776 -0.386087 8.79442 1.8157 -9351 6 35.5875 40.2809 31.6993 12.2791 -13.6127 -29.8257 -9352 4 35.948 40.913 31.0681 -4.17713 12.2213 7.17402 -9353 4 35.6271 39.4709 31.1475 -9.59473 3.36029 20.1077 -9354 6 19.3493 17.5927 17.849 24.123 48.8902 3.26857 -9355 4 19.9577 18.423 17.9915 -34.5112 -38.8316 -9.06029 -9356 4 18.6928 17.806 17.1645 6.15508 1.01267 5.31501 -9357 6 7.96541 28.082 10.7737 20.0283 17.3944 8.50509 -9358 4 8.43659 28.8341 11.2297 -13.1431 -15.7733 -11.3814 -9359 4 7.20109 28.4458 10.3015 -0.215648 4.06143 0.688545 -9360 6 32.1489 39.5869 16.6475 -7.37335 1.81146 -4.92627 -9361 4 31.705 40.4043 16.3332 3.90743 -15.5774 4.53996 -9362 4 31.4977 38.8659 16.5723 3.01217 10.596 3.08762 -9363 6 35.8095 2.63602 18.127 2.07542 -14.8225 4.13142 -9364 4 34.8947 2.32962 18.1713 7.15775 -3.6283 3.09768 -9365 4 35.7135 3.4873 17.7367 2.81673 20.5762 -11.5045 -9366 6 14.9588 39.9585 36.8943 -2.86001 -28.3727 24.0409 -9367 4 15.4545 39.4909 36.2335 10.0689 -8.68258 -13.459 -9368 4 15.0094 40.8569 36.655 2.72867 44.443 -9.08423 -9369 6 18.3115 32.3916 11.4639 8.59274 12.4423 14.7113 -9370 4 18.6438 32.5881 12.3772 -9.2478 -5.5834 -23.9484 -9371 4 17.8762 33.212 11.1576 6.35145 -13.5457 0.164794 -9372 6 14.605 10.3819 4.99774 5.57597 -6.68493 12.6773 -9373 4 13.677 10.4388 4.75284 -6.10435 1.24571 -3.75468 -9374 4 14.6185 10.047 5.91478 4.2493 4.0336 -10.9734 -9375 6 2.02851 14.3408 39.1627 -4.03313 12.5981 -1.48522 -9376 4 2.74992 15.009 39.2086 -14.5088 -8.45155 5.07373 -9377 4 1.21458 14.679 39.6124 19.1623 -3.42757 -8.41789 -9378 6 7.58709 14.1522 32.4651 10.4977 19.6861 -0.504887 -9379 4 6.93593 13.6605 32.9674 -3.57672 2.30039 3.8359 -9380 4 7.5987 15.0834 32.797 -1.90079 -22.9019 -5.87851 -9381 6 6.15309 23.123 37.664 -26.7168 -14.8188 -11.2926 -9382 4 6.52639 23.9838 37.7378 17.5333 20.6862 9.20416 -9383 4 5.45539 23.2608 36.9958 8.40974 -10.7335 8.81374 -9384 6 37.3009 22.5422 4.44282 21.6187 66.9857 0.670839 -9385 4 36.5208 22.1217 4.15693 -30.5217 -23.5005 -12.8181 -9386 4 37.1232 23.5227 4.23696 10.5274 -41.8214 11.62 -9387 6 47.1349 31.0113 5.88613 -14.3653 5.64202 -58.02 -9388 4 46.9542 30.9019 6.7933 -9.29323 -2.10558 39.1512 -9389 4 46.2627 31.2059 5.44524 20.5013 -7.22248 10.5418 -9390 6 54.8094 25.5909 34.9286 -5.37395 41.5808 12.672 -9391 4 54.0266 25.5089 35.4943 -0.981006 -11.4098 -6.26775 -9392 4 0.0616925 26.543 35.1263 -1.5494 -32.4448 -11.2369 -9393 6 37.1551 2.08197 4.79239 -12.5712 23.0197 -22.5278 -9394 4 36.5844 2.86136 4.61445 9.59981 -14.8952 -2.62483 -9395 4 37.0798 1.96202 5.72873 2.5296 -7.23911 19.6989 -9396 6 22.5239 28.6012 8.91155 -7.98869 19.6075 21.4366 -9397 4 22.8946 28.4124 9.79991 -0.853296 -5.89568 -17.4096 -9398 4 22.801 27.9767 8.25343 10.1708 -14.6558 -3.7409 -9399 6 8.64208 27.1509 24.5664 -38.2161 25.5543 4.78276 -9400 4 7.71753 26.8887 24.5582 -5.16372 11.0804 -0.386298 -9401 4 9.04357 26.3309 24.4724 40.7169 -47.477 -5.23592 -9402 6 1.14997 23.727 2.4309 6.46058 8.65979 -14.8341 -9403 4 1.18232 23.9936 1.48373 -6.63581 -4.99587 16.5657 -9404 4 0.310199 23.2733 2.54924 -0.981545 -0.950126 -1.89037 -9405 6 54.3702 30.2259 27.0243 -0.035121 6.58363 -4.50453 -9406 4 54.2615 29.4654 26.4339 1.23903 8.74071 -4.24792 -9407 4 54.6064 30.9974 26.4582 -3.83852 -12.4126 5.30421 -9408 6 0.386829 8.42023 23.9938 5.00922 -16.8445 -6.80376 -9409 4 1.36083 8.4508 24.0758 -8.17173 1.21512 3.08891 -9410 4 54.9524 8.88826 24.7258 9.13745 3.54566 6.13736 -9411 6 16.8971 28.5839 33.3722 23.8511 -30.9569 -4.46587 -9412 4 17.442 28.7831 34.1436 -6.82268 9.96305 3.46007 -9413 4 17.4403 27.8723 32.949 -23.4552 19.8179 6.40974 -9414 6 33.6969 30.8931 0.141175 14.1795 0.777253 -0.635822 -9415 4 34.6278 30.5945 0.162696 -6.8513 6.78484 1.91826 -9416 4 33.3211 30.3583 41.3463 -2.66034 -4.05802 -0.0970656 -9417 6 16.2525 21.5202 34.1552 3.2099 -15.0674 -0.387853 -9418 4 16.0099 20.7546 33.5903 4.90739 13.2878 5.87792 -9419 4 16.6977 21.1376 34.9376 -8.96682 7.2262 -10.6242 -9420 6 0.22977 17.7868 35.7492 -9.57638 -14.7124 1.37696 -9421 4 54.2434 17.9569 35.6827 28.6901 -4.22084 5.11773 -9422 4 0.351694 16.93 36.209 -4.1051 13.1178 -5.65765 -9423 6 16.8289 12.2962 0.019427 11.8958 12.8939 11.6481 -9424 4 17.3016 12.8498 0.703368 -12.3262 -21.137 -14.7379 -9425 4 16.4403 11.4936 0.411486 1.39397 8.07719 2.11333 -9426 6 8.24246 9.54397 36.2629 -25.8472 21.2414 2.40819 -9427 4 7.81464 8.9356 36.8788 1.26461 -2.06425 2.56422 -9428 4 7.48979 10.0869 35.9067 16.4576 -8.29365 1.86334 -9429 6 48.5761 26.718 39.8382 -16.8767 -13.2223 25.9758 -9430 4 48.2189 26.9037 38.9774 0.202946 6.43929 -15.4249 -9431 4 49.4865 26.9849 39.8847 17.129 6.93076 -9.10183 -9432 6 35.4777 1.07865 23.1156 20.3084 9.46551 28.8556 -9433 4 36.0215 1.72656 22.6213 -7.75205 -10.5654 8.45632 -9434 4 35.804 1.12911 24.09 -10.3378 -1.68949 -45.1242 -9435 6 20.2777 30.6326 19.3782 17.168 -16.4055 9.77372 -9436 4 20.2499 31.0311 20.2788 1.56461 -6.55175 -10.0354 -9437 4 20.938 29.881 19.3855 -20.6701 22.3694 2.2449 -9438 6 44.3702 15.9458 1.58361 10.9348 22.193 31.2112 -9439 4 44.4077 15.6379 2.51116 -1.71559 -1.42871 -18.164 -9440 4 44.6431 16.8967 1.66823 -9.97295 -22.8516 -13.6111 -9441 6 53.8845 34.4651 10.6068 -24.0145 7.95167 -19.3224 -9442 4 54.4361 34.2696 11.3314 22.7066 -9.19703 33.7305 -9443 4 54.2985 35.2035 10.1555 0.2437 -1.83103 1.50375 -9444 6 46.1364 32.8471 33.519 4.96533 -12.2334 2.48444 -9445 4 45.9404 33.6629 33.0556 -3.66306 8.73713 -2.86335 -9446 4 47.0477 32.6179 33.2654 -4.26196 1.19291 1.09329 -9447 6 42.1324 21.9098 24.2239 34.4777 -24.9191 34.4505 -9448 4 43.0412 21.5159 24.3646 -28.4667 14.3091 -11.1056 -9449 4 41.7437 21.6811 25.0949 -3.80951 9.2794 -19.6729 -9450 6 8.14185 3.89847 11.6387 2.30661 -15.3192 6.95264 -9451 4 7.35197 4.1174 12.1322 -8.99547 12.8437 -2.29886 -9452 4 8.35392 3.05748 12.0535 10.9023 -1.5691 -3.31016 -9453 6 19.6413 41.6808 9.8267 1.07442 6.29255 0.337359 -9454 4 18.9204 41.094 9.57509 0.414049 2.67892 1.92063 -9455 4 19.352 0.205183 10.6506 0.427822 -12.2572 -10.0953 -9456 6 42.3157 8.41085 31.6785 13.3628 11.5473 -7.23952 -9457 4 41.3969 8.42848 31.9417 -9.73605 -1.80426 0.915182 -9458 4 42.5534 9.35818 31.5624 -0.333442 -16.319 1.99913 -9459 6 26.911 16.154 25.3637 -0.10907 13.2502 -20.6653 -9460 4 26.7939 15.8861 24.4207 -0.565005 2.37017 21.4763 -9461 4 26.6835 15.4121 25.9182 -3.52016 -12.4926 6.14171 -9462 6 48.2345 6.48613 12.6212 -1.55264 -8.09911 -9.8466 -9463 4 48.9652 6.31914 12.0011 -5.93235 3.28214 2.19301 -9464 4 47.4516 6.10442 12.1764 7.36669 2.93589 5.65527 -9465 6 53.4556 41.5274 30.6561 0.928349 -3.66285 -10.4005 -9466 4 53.9738 41.8466 29.9077 -1.68735 -3.84443 -4.80087 -9467 4 53.7246 0.16796 31.3785 5.2081 5.34012 15.7103 -9468 6 47.0719 22.4215 31.8177 3.79963 28.0651 -15.4962 -9469 4 47.8542 22.5824 31.2379 -15.4047 -7.22606 14.7582 -9470 4 46.5391 23.2393 31.6689 5.43499 -22.2824 10.2038 -9471 6 19.5241 5.44646 15.2431 57.7261 9.00726 -25.1025 -9472 4 19.973 4.5781 15.2547 -6.4602 7.66804 1.10752 -9473 4 18.6769 5.33307 15.596 -47.9766 -8.78418 19.1468 -9474 6 14.6808 30.2445 33.392 16.954 11.9814 -17.0239 -9475 4 15.1668 30.8865 32.8123 -10.4914 -16.0898 10.6301 -9476 4 15.2553 29.4559 33.3904 -4.22445 9.80292 -0.52553 -9477 6 28.4427 24.2289 10.4187 -0.774793 -27.6212 -36.8967 -9478 4 29.277 24.4414 10.8128 10.21 14.4589 20.8069 -9479 4 27.7162 24.5027 10.9517 -9.91177 12.6254 22.5109 -9480 6 5.25429 14.4357 24.4952 18.8694 8.38265 -3.5804 -9481 4 4.38598 14.1455 24.6681 -43.369 -9.18674 12.4123 -9482 4 5.45154 13.9758 23.6794 9.52503 -2.95522 -10.1363 -9483 6 26.3476 19.2988 19.1857 11.4015 -18.2951 -12.5804 -9484 4 26.5417 20.1869 19.4853 3.52858 10.6793 1.31948 -9485 4 27.146 18.9308 18.7141 -21.2465 13.7562 17.259 -9486 6 28.5834 7.44603 13.1845 8.68409 29.8386 11.3246 -9487 4 28.3961 6.55455 12.9442 -2.45324 -19.0833 -9.20205 -9488 4 29.0571 7.89665 12.4686 -5.14786 -6.54739 -1.73865 -9489 6 5.35742 27.1473 37.0464 13.0843 -4.728 13.8292 -9490 4 6.09472 26.8663 37.6487 -17.7636 2.66278 -18.049 -9491 4 5.49884 28.0724 36.7882 1.93418 -3.90879 0.386893 -9492 6 53.1466 13.4128 16.1104 33.6732 -23.607 0.886679 -9493 4 54.0532 13.0537 15.8959 -24.4904 18.1541 2.55443 -9494 4 52.6056 12.6236 16.2807 -0.490038 10.6025 -2.0621 -9495 6 45.4595 1.03561 24.6152 0.883869 7.22473 8.82703 -9496 4 44.8005 0.912307 23.9218 -0.0838502 -1.3445 -1.23214 -9497 4 44.9845 0.757767 25.4168 6.19386 0.932014 -5.94613 -9498 6 50.1542 2.38642 13.9319 -2.4774 12.931 -1.3926 -9499 4 50.7815 2.76975 13.3044 0.014285 -4.08681 1.38242 -9500 4 49.5062 3.09016 14.0651 -1.63783 -0.639647 1.83323 -9501 6 19.5885 31.0175 39.1657 -10.9837 -21.6636 -18.6241 -9502 4 19.8079 30.3148 38.4832 -5.60324 21.7545 20.6111 -9503 4 18.6148 30.9453 39.3442 26.0441 2.6939 -5.02925 -9504 6 19.2491 14.7106 10.8907 20.9533 -11.5465 -13.087 -9505 4 20.0062 14.1954 10.4207 -44.2836 18.7066 28.5885 -9506 4 18.7045 14.0688 11.3882 14.1221 2.37282 -8.47947 -9507 6 4.44986 39.5549 20.1348 -7.46971 20.8744 22.4052 -9508 4 3.99116 40.4291 20.2667 12.3042 -22.0468 -4.08326 -9509 4 4.78876 39.261 21.0122 -11.398 5.88582 -21.7205 -9510 6 29.0264 13.3645 23.891 3.80322 20.0192 21.3715 -9511 4 28.7263 12.4558 23.8574 1.87437 -3.97007 -2.19356 -9512 4 28.9189 13.5991 24.8488 7.01015 0.856522 -27.3099 -9513 6 17.0674 2.76528 17.6511 13.6679 -9.88609 -24.0062 -9514 4 16.9089 3.43106 16.9566 -0.337692 -4.66999 2.92783 -9515 4 17.7694 2.16287 17.2836 -16.7881 13.7863 9.44417 -9516 6 43.472 18.0456 17.7207 2.90116 -6.00314 -10.3001 -9517 4 43.5328 17.0661 17.6262 0.602958 19.7978 9.46789 -9518 4 43.5843 18.2505 18.6627 0.176297 -8.32564 -1.3476 -9519 6 25.7838 40.7303 1.24723 -3.64329 26.5644 -28.0564 -9520 4 26.2198 41.3001 1.88369 1.46132 -2.86659 8.1156 -9521 4 25.5777 41.3986 0.532216 -2.57635 -28.6607 13.7824 -9522 6 0.458758 22.8928 6.22327 -2.28892 -3.37321 -2.62932 -9523 4 0.911995 22.0955 5.88137 -3.49653 6.37629 4.11618 -9524 4 1.15027 23.4262 6.63616 1.38998 -0.611711 -3.15133 -9525 6 26.2502 35.0072 18.629 11.2346 5.37396 -16.6635 -9526 4 25.9102 35.926 18.5821 -1.77201 -16.2127 4.61622 -9527 4 25.7094 34.5197 19.2578 -0.594129 4.22999 1.61862 -9528 6 16.1509 31.8837 7.54876 40.1408 -29.5169 -1.86921 -9529 4 16.9528 31.2446 7.38162 -38.5191 36.6879 6.5811 -9530 4 16.2422 32.6162 6.9246 8.25996 -4.45471 -3.71716 -9531 6 22.9569 16.8424 28.5503 -18.0144 15.9011 -12.9281 -9532 4 23.0242 16.0615 27.9964 2.65193 -8.47258 -0.731728 -9533 4 22.0914 17.2685 28.2981 23.9965 -14.5366 15.8079 -9534 6 48.817 29.3453 32.1483 10.2159 -3.67765 25.2301 -9535 4 47.913 29.23 31.8533 -10.4354 1.38436 -5.08298 -9536 4 48.8482 28.9579 33.0615 0.343667 8.53482 -20.1614 -9537 6 13.1275 24.857 5.54597 -15.7655 12.0094 -10.6158 -9538 4 12.8967 24.1126 4.95892 -3.19147 7.26676 2.83523 -9539 4 12.4206 25.5605 5.45199 17.9822 -22.1189 1.55356 -9540 6 10.967 20.7149 15.8389 3.49035 -8.57129 -4.90872 -9541 4 10.8232 20.5385 14.8814 6.84933 2.21154 19.4522 -9542 4 11.8211 20.2878 16.0966 -18.2767 7.30584 -13.8769 -9543 6 13.8574 18.376 6.9425 -18.5688 18.5302 -26.9748 -9544 4 14.0551 19.3329 6.99178 3.58444 -10.9562 5.12073 -9545 4 14.2751 17.8929 7.64202 12.8225 -6.30863 19.0643 -9546 6 13.8485 12.9413 30.6405 -7.33075 -24.1801 -9.47477 -9547 4 13.9233 12.3923 29.8469 14.5901 9.31788 -1.12157 -9548 4 13.0284 12.552 30.9634 -3.13873 11.8242 15.1361 -9549 6 17.1199 6.33729 31.2705 58.4108 60.4292 21.9502 -9550 4 16.7347 7.19592 31.0485 -2.55536 -2.82538 -1.05014 -9551 4 16.4932 5.72664 31.0455 -61.4006 -55.6776 -22.0804 -9552 6 7.63858 23.4232 20.5528 2.70849 -2.51933 -11.6338 -9553 4 7.34936 23.0623 19.6936 2.42656 1.66026 8.60009 -9554 4 8.06294 24.2698 20.3247 -2.54411 -7.58863 2.30144 -9555 6 15.6012 36.6828 25.6308 12.0382 0.865576 2.42327 -9556 4 16.546 36.4866 25.8589 -19.7129 13.5166 -7.57965 -9557 4 15.5566 37.5233 25.1245 15.7859 -9.47529 6.9914 -9558 6 0.738662 10.4099 22.1708 -26.6289 -22.4058 -14.7131 -9559 4 0.0268398 10.3645 21.4686 20.8647 0.21224 20.3485 -9560 4 0.555589 9.63254 22.7491 3.84168 18.0907 -12.5939 -9561 6 33.5034 17.3959 33.5951 21.201 30.6084 -13.4811 -9562 4 33.5895 18.3893 33.3705 0.776259 -45.1899 5.95193 -9563 4 34.1847 16.8766 33.1005 -9.04546 14.4589 8.38708 -9564 6 21.6622 19.013 20.7578 31.9274 -22.1518 -4.15649 -9565 4 22.4096 19.6032 20.9777 -11.5486 -3.71871 -1.82252 -9566 4 22.1307 18.1402 20.6082 -20.9219 25.304 3.1187 -9567 6 41.7583 19.992 16.8792 -6.68772 4.02339 -8.69865 -9568 4 42.2438 19.1637 16.9575 3.64207 -5.49479 0.617993 -9569 4 41.579 20.1273 15.9247 3.71595 -2.33609 11.0843 -9570 6 12.0355 14.9654 17.6922 -21.5841 1.26502 -18.8824 -9571 4 11.2182 14.5976 17.276 14.8021 5.3277 12.4216 -9572 4 12.4319 14.255 18.1907 -0.352973 -10.2116 7.98966 -9573 6 23.0172 11.4191 40.7206 -10.7217 24.0381 44.0704 -9574 4 22.9528 12.3236 41.1181 -0.480688 -24.3492 -4.33206 -9575 4 23.3445 11.5906 39.8675 15.3819 0.516123 -37.823 -9576 6 21.0055 28.3299 24.5595 -23.1154 26.0001 -7.02903 -9577 4 20.2855 28.1767 25.1713 -12.8069 16.7504 -3.2857 -9578 4 21.5564 27.6405 24.838 35.6802 -30.9994 4.41974 -9579 6 19.406 13.705 31.9364 14.5236 -8.57279 10.3452 -9580 4 18.7521 13.9469 31.2876 -5.81883 0.611034 -8.78432 -9581 4 18.9142 13.6788 32.7621 -0.186305 1.04404 6.29106 -9582 6 21.5918 2.86134 24.7058 -12.3779 12.1824 -8.79066 -9583 4 21.7274 3.16074 23.7816 9.4572 -7.89437 13.7797 -9584 4 22.4025 2.45534 25.0386 5.22934 2.42127 -4.70961 -9585 6 11.3487 29.9838 18.827 10.5554 -3.16976 4.47537 -9586 4 10.5352 30.5203 18.751 15.2364 -2.61973 2.60085 -9587 4 12.0043 30.4181 19.4217 -22.0541 -6.82347 -15.9561 -9588 6 14.6417 22.3529 8.3686 35.183 35.1516 7.4005 -9589 4 14.0314 23.0645 8.61446 -9.87113 -8.59651 0.991548 -9590 4 15.5117 22.8693 8.31218 -34.203 -30.7208 1.23805 -9591 6 43.9533 23.6664 17.2647 -9.15762 31.6597 -10.4885 -9592 4 44.7744 23.2846 16.9678 11.7125 -13.1472 -3.62648 -9593 4 43.5104 22.9908 17.7726 1.91474 -8.51607 6.21827 -9594 6 28.003 25.5014 27.4986 6.23457 -29.1533 -5.23677 -9595 4 27.4849 26.2827 27.5489 -17.6876 27.9136 1.36856 -9596 4 28.906 25.8001 27.3829 8.21911 6.89622 0.0845564 -9597 6 19.1046 26.8047 33.1413 12.2661 11.24 -48.0243 -9598 4 19.0365 26.4782 32.1917 1.11076 11.999 35.7369 -9599 4 19.4769 27.7251 33.0545 -9.7287 -23.6705 8.34301 -9600 6 6.37289 19.3428 5.67363 -3.21133 -16.2285 8.07537 -9601 4 6.7336 20.019 5.09886 3.22925 8.22387 -6.14542 -9602 4 5.58923 19.7346 6.08082 -0.796808 3.74051 2.3056 -9603 6 37.4835 28.3972 9.67963 -16.8252 8.64443 -22.9196 -9604 4 37.8384 28.0931 10.5154 1.79485 -10.7977 1.13655 -9605 4 37.3056 27.6421 9.07717 9.05958 5.47813 21.4583 -9606 6 17.6994 27.086 11.7957 -23.9049 -9.71644 -0.114793 -9607 4 16.9894 26.5877 11.2784 19.3807 18.9653 23.0761 -9608 4 17.3772 27.2467 12.7205 1.32974 -4.86863 -22.184 -9609 6 12.8804 1.95044 24.1635 -16.9081 23.6463 -41.3936 -9610 4 12.0123 2.42693 23.9788 24.6345 -20.1638 18.4271 -9611 4 12.9602 1.63912 25.0531 -11.2641 -4.9093 21.6908 -9612 6 27.8486 37.1249 33.3037 14.5525 0.843809 -12.8082 -9613 4 27.8306 37.7566 32.5563 -0.261378 -9.54721 11.1245 -9614 4 28.4641 36.389 33.0416 -14.495 18.5162 4.94281 -9615 6 18.6769 12.3657 6.31954 -0.243732 -29.9473 12.6257 -9616 4 18.5317 11.3932 6.23771 0.963018 17.4883 6.62231 -9617 4 18.5535 12.6707 5.42951 -3.51714 10.9469 -19.8301 -9618 6 10.1845 29.3127 24.783 -1.36331 5.89889 -4.08473 -9619 4 10.7465 29.1085 25.5662 -10.353 -5.60455 -9.55427 -9620 4 9.5047 28.6152 24.6271 17.6265 9.93184 12.3415 -9621 6 7.25219 3.30976 16.2618 16.5712 6.01323 38.0962 -9622 4 7.85224 3.92676 16.743 -7.28275 2.21025 -21.7569 -9623 4 7.07626 2.67339 16.9792 -0.839688 -3.96601 -21.0406 -9624 6 32.2032 37.556 1.10106 -1.45173 2.30566 -1.67736 -9625 4 31.7319 37.0242 1.72254 -12.3544 -30.6614 1.12887 -9626 4 32.1826 38.3533 1.61216 9.84976 31.1212 -1.90535 -9627 6 10.4132 10.1536 6.41547 2.6172 -5.66149 -5.23088 -9628 4 9.51094 10.4988 6.43252 -1.43241 7.72691 5.99088 -9629 4 10.888 10.4598 7.20926 -10.4429 3.02901 -4.20627 -9630 6 16.1922 23.2473 37.3836 13.4596 17.9231 -6.20094 -9631 4 16.4628 23.5362 38.2769 -1.8179 -2.41291 -6.91424 -9632 4 16.622 23.8878 36.7607 -9.68345 -13.0364 13.8052 -9633 6 24.0933 14.3373 36.5438 -0.810617 7.47513 6.008 -9634 4 25.0172 14.0983 36.6068 9.64822 -3.29568 0.232999 -9635 4 23.7283 14.0715 37.4031 -3.57511 2.15125 -3.19243 -9636 6 27.4694 18.5535 28.7878 -22.2405 -8.90967 9.68842 -9637 4 27.2463 18.155 29.6474 7.14424 4.94771 -10.1046 -9638 4 26.6163 18.5328 28.3045 10.7583 2.44378 -0.411902 -9639 6 51.5617 10.4928 1.56364 -46.044 -5.31617 -17.9438 -9640 4 50.711 10.1131 1.91707 23.1705 13.8427 -10.0979 -9641 4 52.2015 10.4284 2.24991 18.8641 -3.04547 25.194 -9642 6 31.1163 39.6073 27.5052 16.7753 -4.77526 -29.689 -9643 4 30.6203 39.2762 28.2489 -5.6675 10.9492 15.0474 -9644 4 31.3773 40.5466 27.6182 -8.67746 -20.5696 10.3555 -9645 6 6.90447 35.9666 14.3264 -30.1691 -4.34312 14.222 -9646 4 7.61578 36.3042 13.808 21.2575 5.14969 -9.00238 -9647 4 7.11482 35.0613 14.5906 3.01946 -0.973686 -2.74545 -9648 6 45.5514 7.57029 29.1841 -25.615 -5.69379 -2.02895 -9649 4 44.9198 7.51228 28.4263 15.6429 0.393509 16.1679 -9650 4 45.0848 7.11279 29.9186 7.09759 5.05324 -8.24334 -9651 6 31.3626 20.5603 31.6216 46.5235 7.85379 -13.5612 -9652 4 31.9622 21.3332 31.7077 -20.5518 -6.12612 6.97271 -9653 4 31.9328 19.9839 31.0823 -17.3109 -3.90007 7.28444 -9654 6 43.0286 31.1606 10.377 -16.6603 7.93207 28.9623 -9655 4 42.0878 30.8529 10.4887 24.119 8.07098 -2.29185 -9656 4 43.3099 31.4942 11.272 -6.72297 -13.7816 -28.1326 -9657 6 50.925 25.5606 12.6461 -27.6852 -6.08767 20.8539 -9658 4 50.917 26.3683 12.1731 -8.31821 35.0391 -16.2433 -9659 4 51.8024 25.2628 12.5325 34.7451 -18.8429 0.848912 -9660 6 29.3305 2.97987 3.64738 17.2649 -36.5424 -5.61333 -9661 4 29.6156 3.84373 3.86529 8.03017 35.8359 9.57326 -9662 4 28.4158 3.03535 3.41816 -23.9953 6.75187 -10.8335 -9663 6 53.9216 32.1051 20.3724 -11.2223 -0.478332 -4.16652 -9664 4 54.8523 32.157 20.1701 8.27859 1.2318 1.83366 -9665 4 53.5473 31.7256 19.5583 -4.88871 3.83013 8.11791 -9666 6 41.7036 29.5569 6.48267 17.2638 16.7804 -5.64052 -9667 4 40.7698 29.5903 6.27928 -11.16 5.83742 -3.44443 -9668 4 42.1548 30.305 5.99503 -16.5783 -19.3567 12.2041 -9669 6 37.8345 24.5719 39.3019 -13.0469 -9.65298 -3.86921 -9670 4 37.225 24.2046 38.6488 4.5791 4.74434 1.49749 -9671 4 37.4276 24.3068 40.1372 5.55374 4.45167 1.85829 -9672 6 46.5621 27.5658 23.2944 -23.9279 -33.0439 -11.1022 -9673 4 46.4387 27.4786 24.2739 -2.64996 -4.90603 -22.3791 -9674 4 45.938 26.8598 22.8442 32.7587 35.3455 32.269 -9675 6 9.23408 27.197 8.34767 -28.7607 6.82988 18.9345 -9676 4 8.89078 27.6282 9.16421 9.10203 -8.06063 -16.3167 -9677 4 10.1694 27.1106 8.44975 24.8451 0.83524 4.07321 -9678 6 36.0586 34.168 13.9947 0.546429 -20.5208 -0.995849 -9679 4 35.8317 33.2019 13.9926 1.47243 21.3574 0.844463 -9680 4 36.7518 34.2454 13.3214 -1.12661 -0.38848 2.20278 -9681 6 51.6812 14.492 12.3108 14.2062 7.57429 -10.7818 -9682 4 52.2015 14.4126 11.4771 -7.23407 7.45688 18.698 -9683 4 51.902 15.34 12.7416 -3.60656 -14.3916 -9.37264 -9684 6 15.248 19.6366 32.4109 27.4357 -16.6396 -20.9158 -9685 4 15.2931 19.2358 31.5053 -3.54534 7.22564 18.4797 -9686 4 14.3328 19.7639 32.5881 -28.0981 2.1384 2.91772 -9687 6 27.6849 24.6479 38.3573 2.41004 -14.3506 -18.7558 -9688 4 27.9256 25.2107 39.0738 -0.349992 17.1553 25.2623 -9689 4 28.4455 24.6938 37.7731 2.45273 -2.47407 -6.18841 -9690 6 37.5344 9.26205 13.6222 2.62805 -1.42602 2.92011 -9691 4 37.9029 8.73293 14.3466 0.897712 0.834078 0.0180659 -9692 4 37.323 10.115 14.0326 -0.799981 -1.44542 -1.10758 -9693 6 20.9013 33.2307 26.2512 6.46074 3.54373 3.40895 -9694 4 21.2661 33.4546 27.1222 -3.70394 5.03607 -5.2507 -9695 4 21.0534 32.294 26.1755 2.06129 -12.757 -1.69162 -9696 6 6.58179 13.9421 35.2385 -0.161437 -23.8226 2.06013 -9697 4 6.46846 12.9778 35.1898 -10.847 5.63462 -0.921172 -9698 4 7.53649 14.0007 35.2781 8.40152 11.229 1.63712 -9699 6 10.0736 7.47184 6.87074 6.29005 1.76204 -5.26249 -9700 4 9.16789 7.18556 6.66525 -0.124912 3.45645 -0.864518 -9701 4 10.1825 8.41968 6.63706 -5.90018 -13.0861 3.35766 -9702 6 31.1989 5.96627 11.4256 47.5137 28.7614 23.6553 -9703 4 31.4466 6.13876 12.388 -20.2952 -9.94335 -33.1747 -9704 4 32.0308 6.26994 10.9806 -22.1211 -12.2896 5.82222 -9705 6 12.1387 3.84993 35.2935 2.49551 -0.304387 23.4243 -9706 4 12.8187 4.19174 34.7257 10.4227 4.50872 -14.559 -9707 4 12.5185 4.00559 36.1769 -9.60543 -1.42105 -7.76228 -9708 6 5.33665 6.07757 27.6447 8.69228 -34.5823 40.5077 -9709 4 5.10952 6.83187 28.1919 -5.14709 12.9851 -0.252954 -9710 4 5.24124 6.31071 26.7545 -7.00092 22.4827 -45.3835 -9711 6 13.1372 33.5675 1.68451 12.1014 31.5323 -4.45098 -9712 4 12.5865 33.1501 1.03303 -8.81838 -7.47149 -8.20936 -9713 4 13.3352 34.4765 1.32576 -5.5291 -24.3721 14.4697 -9714 6 44.6567 10.4099 29.0319 -12.4525 3.56979 -21.9228 -9715 4 44.5737 9.45178 29.0051 9.95574 -3.72472 2.79876 -9716 4 44.0317 10.7133 28.332 10.7873 2.60441 13.9487 -9717 6 9.14585 24.5947 6.38022 15.9839 26.3438 -7.73853 -9718 4 8.92734 24.382 5.47582 -9.1117 -9.61509 -8.5024 -9719 4 9.72625 25.3768 6.21639 -5.50996 -10.1894 15.5503 -9720 6 52.5653 27.2618 21.6392 -6.48047 6.16108 13.4347 -9721 4 52.5564 26.3196 21.8908 4.78081 5.6644 -14.1528 -9722 4 52.8195 27.3969 20.7225 3.24319 -11.7343 -6.41363 -9723 6 7.29679 16.9603 33.544 -1.27463 2.76823 -11.9762 -9724 4 7.39152 17.7215 32.9493 2.03275 -0.910573 2.88066 -9725 4 6.37085 16.7082 33.4809 -4.66481 0.778096 -0.770576 -9726 6 43.9289 25.2227 7.97871 -4.96366 -10.0233 8.38699 -9727 4 43.2519 24.7308 8.49213 12.2574 5.67032 -8.3389 -9728 4 43.4276 25.9018 7.51862 -3.04483 5.5605 -3.23664 -9729 6 2.07953 27.1233 13.6028 0.0104954 7.16496 -8.77242 -9730 4 2.15896 26.2371 13.9627 -2.1358 -7.6126 6.04882 -9731 4 2.6502 27.1018 12.8141 -2.23666 2.89631 3.72058 -9732 6 37.3141 18.284 2.18477 -5.94753 -1.23785 7.60386 -9733 4 37.4961 17.5691 1.55591 -3.17432 -0.490531 -1.7774 -9734 4 36.7255 18.8979 1.7415 -3.03937 1.4219 -5.67571 -9735 6 25.0022 10.0655 0.429871 -30.1443 -7.37242 -0.593153 -9736 4 24.272 10.366 41.7528 14.2211 1.75124 5.05026 -9737 4 24.5705 9.40237 1.00583 14.7283 12.1051 -6.86513 diff --git a/examples/amoeba/dump.ubi.32 b/examples/amoeba/dump.ubi.32 deleted file mode 100644 index 743c5e68dc..0000000000 --- a/examples/amoeba/dump.ubi.32 +++ /dev/null @@ -1,19492 +0,0 @@ -ITEM: TIMESTEP -0 -ITEM: NUMBER OF ATOMS -9737 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 5.4990000000000002e+01 -0.0000000000000000e+00 4.1909999999999997e+01 -0.0000000000000000e+00 4.1909999999999997e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 9.9631 5.60476 0.008413 6.29384 29.5246 19.0744 -2 2 9.59585 5.61686 40.5223 49.6095 -15.082 -19.7261 -3 2 8.19009 6.07902 40.3725 -38.3002 -36.0401 31.6494 -4 3 7.228 5.27674 40.5663 25.6537 34.3003 -15.2325 -5 4 9.24854 5.32486 0.671238 -4.4712 -3.37565 -7.28982 -6 4 10.3108 6.54317 0.309331 -11.8382 -28.5043 -8.77497 -7 4 10.7093 4.95217 0.170763 9.79439 -2.80927 4.02983 -8 4 10.3426 6.38567 40.0332 -19.5644 -29.2331 3.89265 -9 2 9.77742 4.13431 39.9813 -28.2245 -12.7597 2.79543 -10 2 9.48564 3.81758 38.4974 43.5672 -24.1926 -8.96475 -11 5 10.1176 2.11667 38.0047 -9.19737 11.9016 12.5734 -12 2 9.21456 1.10205 39.2112 31.2522 23.9396 11.6177 -13 4 8.99594 3.48122 40.5964 28.5446 19.8656 -13.413 -14 4 10.8136 3.75653 40.1807 -3.6049 4.77507 7.99264 -15 4 10.0744 4.47991 37.8007 -16.03 7.55553 14.4224 -16 4 8.42529 3.84402 38.2863 -20.8998 9.83371 -6.83213 -17 4 9.47601 1.46641 40.2263 -2.07893 -1.87234 0.341628 -18 4 9.53146 0.065851 39.1813 1.34892 -20.4385 -9.90461 -19 4 8.1577 1.22135 39.0727 -30.8502 -1.48556 -5.54631 -20 1 8.07565 7.408 40.3203 38.3461 4.68909 -14.5778 -21 2 6.84679 8.08521 40.1985 -59.0929 12.5985 8.76694 -22 2 6.18936 7.48414 38.9048 -11.7821 0.575019 41.3478 -23 3 6.7346 7.67531 37.8418 13.9355 0.826162 -41.115 -24 4 8.95137 7.92937 40.1018 -13.7432 5.12585 4.7357 -25 4 6.17099 7.78674 41.0889 17.7478 9.29385 -16.8634 -26 2 7.04543 9.68435 40.1788 6.06779 -36.4281 36.3417 -27 2 5.78315 10.5437 40.1541 10.0153 13.6856 -31.2349 -28 2 4.87823 10.4891 38.8981 8.0898 32.2503 -21.0798 -29 3 5.10035 11.2936 37.9551 -6.38068 -25.249 23.2549 -30 1 3.78765 9.69754 38.9447 7.74282 -10.5609 -2.0448 -31 4 7.77413 9.91905 39.4336 6.93206 10.4159 -38.5359 -32 4 7.65159 10.0279 41.0787 -15.5363 -12.6708 -2.68622 -33 4 6.21166 11.5927 40.0353 -14.0103 -9.11046 14.0038 -34 4 5.24199 10.4471 41.1154 -6.90019 6.03163 0.39253 -35 4 3.64982 9.13451 39.798 -8.63839 -3.4701 -4.98201 -36 4 3.18526 9.53497 38.0983 12.4509 11.2825 18.2671 -37 1 5.03649 6.76821 39.0271 29.2025 12.626 -49.9624 -38 2 4.1742 6.30537 37.9199 2.45922 -5.77224 11.4432 -39 2 2.7281 6.64357 38.2301 -33.27 13.9739 -28.2234 -40 3 2.48558 7.27851 39.247 -7.20167 1.94081 18.2399 -41 4 4.56901 6.92293 39.8729 -36.0812 -3.10094 47.9009 -42 4 4.41115 6.93099 37.0362 4.08063 -6.87028 -11.6053 -43 2 4.30896 4.77224 37.6863 5.60806 -34.2262 -10.7438 -44 2 3.61194 3.83713 38.7945 21.7291 41.8848 -7.6362 -45 2 5.81981 4.32753 37.5156 -0.302636 -10.5955 -12.2236 -46 2 3.74184 2.37563 38.4472 -21.3499 -20.7746 -35.862 -47 4 3.79188 4.51145 36.7016 6.3754 10.432 9.00978 -48 4 2.54774 4.08441 38.8361 -15.7139 1.18722 1.17999 -49 4 4.01487 4.13828 39.7949 0.987415 -11.5324 -1.87366 -50 4 6.38959 4.49596 38.46 -5.87199 -9.93517 1.91854 -51 4 6.36771 4.97617 36.7815 -14.8228 -10.6264 -0.132465 -52 4 5.90888 3.19548 37.1534 1.72477 39.701 11.5881 -53 4 3.39383 2.18531 37.3739 6.37275 7.50384 16.1992 -54 4 3.10231 1.69487 39.022 -2.76045 -1.11045 15.6564 -55 4 4.76015 2.00007 38.4839 16.883 -5.45935 8.37891 -56 1 1.68415 6.36719 37.3348 37.2769 -12.9922 15.6035 -57 2 0.304736 6.65563 37.6783 -19.186 -35.7743 -0.468083 -58 2 54.3638 5.41499 37.39 23.5408 9.01503 -19.9847 -59 3 54.8016 4.481 36.67 -18.0502 12.9096 17.6943 -60 4 1.81134 5.6821 36.5646 -2.38907 6.77101 2.69516 -61 4 0.26398 6.68603 38.7911 -5.02605 17.0245 3.77253 -62 2 54.6928 7.87629 36.9427 9.14228 37.5998 28.2049 -63 2 0.656467 9.08157 36.7109 -0.0956801 -8.96924 -14.639 -64 2 1.56488 9.23116 35.5658 -28.7887 -16.4207 21.28 -65 2 0.518242 10.1807 37.599 12.0453 -33.0617 -42.3022 -66 2 2.2549 10.4284 35.3456 -0.685553 9.51875 21.9154 -67 2 1.26608 11.2953 37.3573 -6.55985 56.8791 72.0683 -68 2 2.14201 11.4551 36.3269 43.9558 24.4422 -61.5967 -69 4 53.8494 8.28091 37.614 11.6877 -9.2043 -14.6276 -70 4 54.1796 7.56606 36.0251 1.84695 0.514683 -15.8045 -71 4 1.67027 8.40603 34.832 -2.56062 3.42592 3.08894 -72 4 54.8243 10.1788 38.4192 -16.1978 -2.83683 23.7337 -73 4 2.90465 10.5398 34.4584 1.04403 1.06161 3.93542 -74 4 1.2044 12.0958 38.199 3.2453 -15.1518 -32.2206 -75 4 2.76002 12.4636 36.1598 -24.4207 -43.5556 11.8549 -76 1 53.0705 5.5478 37.8043 -13.4682 25.7632 10.8407 -77 2 51.945 4.63101 37.5291 33.8243 -29.5042 -37.7332 -78 2 50.7838 5.44293 36.986 4.21111 -0.422475 -19.7833 -79 3 50.2621 6.29965 37.7355 -1.55474 -12.1519 -25.7528 -80 4 52.801 6.45436 38.3333 3.61532 -42.2821 -15.9338 -81 4 52.3053 3.83112 36.7028 -14.0928 30.7972 24.0178 -82 2 51.5456 3.79903 38.7793 9.75018 1.06621 4.26496 -83 2 50.3519 2.79661 38.4832 35.7171 10.1602 1.47909 -84 2 52.8174 3.02556 39.2171 -10.4567 -30.55 12.3487 -85 4 51.3202 4.51835 39.6193 -10.3559 -7.38818 -7.14654 -86 4 50.5612 2.13754 37.5331 -9.75373 16.6535 26.894 -87 4 49.4557 3.43665 38.3668 -10.8276 -7.01925 -6.76558 -88 4 50.2008 2.17632 39.4156 -2.83245 -1.1989 -13.0752 -89 4 53.3224 3.52205 40.064 3.32837 5.49303 2.41605 -90 4 53.5736 2.86114 38.4382 5.5955 2.25759 -8.48168 -91 4 52.5769 1.98664 39.5815 -0.855844 10.0945 -0.110617 -92 1 50.4393 5.19673 35.6351 -19.7264 9.67141 42.9571 -93 2 49.1691 5.71413 35.1171 8.57247 21.8964 -7.76629 -94 2 48.0882 4.65728 35.3507 -19.9883 30.8425 14.9148 -95 3 48.2827 3.53875 34.9335 -4.48089 -38.0316 -8.70437 -96 4 50.7426 4.33028 35.1784 2.31221 -1.81777 -1.86606 -97 4 48.9711 6.6281 35.7521 -11.2206 -0.672417 -16.6265 -98 2 49.2032 6.03091 33.5236 -0.851856 65.2811 26.1578 -99 2 47.9587 6.87959 32.9935 21.6676 -24.5773 11.3759 -100 2 48.0434 7.32811 31.5002 51.7858 -12.5586 -5.19204 -101 2 48.2074 6.22405 30.3724 28.294 -23.2516 17.4346 -102 1 48.1983 6.77555 28.9911 -71.9632 -28.6889 -6.605 -103 4 49.3393 5.11986 33.0139 -2.20502 -45.3575 -27.512 -104 4 50.0955 6.63289 33.1892 -0.645528 -4.64769 17.8413 -105 4 47.8013 7.74388 33.6913 1.36166 0.224784 -7.99748 -106 4 47.0904 6.22572 33.1496 -13.2574 -0.904539 -3.87726 -107 4 49.004 7.98659 31.3992 -27.9616 -9.11626 3.58403 -108 4 47.1978 7.96127 31.27 -20.0009 14.5444 -5.73856 -109 4 47.5417 5.33248 30.4619 -18.467 18.3391 -3.45282 -110 4 49.1897 5.66674 30.5732 -8.59668 22.4275 -14.4147 -111 4 48.9982 7.27964 28.7313 27.9214 19.6218 -9.55881 -112 4 47.3685 7.40493 28.8518 27.8731 -11.8414 7.77703 -113 4 48.0065 6.08598 28.2169 17.275 11.5652 28.2934 -114 1 46.9206 5.03778 35.9702 10.3577 18.9682 5.15831 -115 2 45.6557 4.25932 36.0398 9.08885 -0.641191 -14.1305 -116 2 44.8836 4.39003 34.674 17.924 -7.95306 73.8288 -117 3 45.3111 5.13887 33.8455 4.25406 24.8458 -47.415 -118 4 46.9247 5.98842 36.4259 -8.42518 -21.6093 -9.66 -119 4 45.9322 3.16772 36.074 -4.07513 2.77881 8.35057 -120 2 44.7235 4.66099 37.2497 -7.79148 27.6424 25.8282 -121 3 44.4559 6.1146 37.2032 37.085 -18.356 15.5747 -122 2 45.2448 4.26963 38.7181 22.7861 29.0575 -8.8559 -123 4 43.727 4.13168 37.1283 17.3832 10.5512 -0.864114 -124 4 45.2761 6.59903 37.5183 -34.0557 -21.4787 -11.7364 -125 4 45.8733 4.97275 39.4014 -10.271 -7.81482 -36.7347 -126 4 45.822 3.36133 38.5799 14.1835 -15.9263 3.29814 -127 4 44.4672 3.97387 39.4102 -27.3329 -5.40347 3.37723 -128 1 43.7561 3.68722 34.6039 -10.1769 -38.5504 10.0379 -129 2 42.7898 3.65331 33.5354 16.9998 -6.12306 -24.86 -130 2 41.7694 4.78815 33.7404 2.26966 -0.410412 -51.1213 -131 3 41.2522 5.37284 32.7445 13.6537 -18.3748 18.9894 -132 4 43.5295 2.98811 35.3697 5.99608 22.1557 -16.865 -133 4 43.3523 3.94914 32.5036 -19.5402 -19.5629 37.0771 -134 2 42.0755 2.18627 33.4863 21.9074 34.2086 -29.4327 -135 2 42.9391 0.859767 33.721 -6.85443 30.257 35.6042 -136 2 42.2358 41.4668 33.4285 -9.81834 -3.65893 -31.5778 -137 2 44.2283 0.854864 32.9471 53.2312 13.9788 40.9195 -138 4 41.6117 2.20331 32.4686 -4.39523 -13.2201 2.61812 -139 4 41.2586 2.27352 34.2121 -10.6776 -10.6054 4.67488 -140 4 43.2056 0.83773 34.8124 -0.343624 1.56324 -2.51079 -141 4 42.8118 40.5237 33.3983 6.69029 -0.569008 16.3673 -142 4 41.9597 41.5484 32.3684 -17.7546 -2.75522 -9.07631 -143 4 41.3245 41.3357 34.0216 -8.62626 -3.98831 3.9624 -144 4 44.0827 0.853311 31.8896 -3.53557 -4.02089 -36.565 -145 4 44.8236 41.822 33.2847 -5.06735 25.2561 -15.1823 -146 4 44.8583 1.80877 33.1923 -14.5958 -31.7921 -4.90526 -147 1 41.5264 5.19611 34.9737 -24.8334 44.6246 6.63495 -148 2 40.6685 6.33721 35.2699 -7.96634 19.3021 -16.1623 -149 2 41.3876 7.74941 35.097 -11.5591 -21.8484 1.81155 -150 3 40.7047 8.75309 34.8417 -6.4948 4.14558 0.128999 -151 4 41.7654 4.68652 35.8013 13.1043 -20.8107 18.8359 -152 4 39.8731 6.44712 34.4383 10.8594 -11.0445 14.3032 -153 2 39.8592 6.12601 36.6093 -15.5564 -7.24317 -37.5678 -154 3 40.7443 5.88444 37.6633 23.6025 16.5055 19.3857 -155 2 38.9047 4.85477 36.5395 -12.0583 61.1722 12.675 -156 4 39.322 7.07341 36.7706 -11.99 4.52079 9.89046 -157 4 41.1265 6.74598 37.8781 -3.93551 -10.4676 -4.79928 -158 4 38.0585 4.98564 35.7954 18.0693 -6.53498 -0.435941 -159 4 38.3566 4.77654 37.5171 8.14363 -6.92414 -3.72239 -160 4 39.543 3.99696 36.3828 0.165947 -30.6128 -6.86199 -161 1 42.7342 7.80416 35.136 -13.9315 11.8694 11.7976 -162 2 43.5142 9.02936 34.9481 17.7181 -46.9691 35.2138 -163 2 44.5073 9.42999 36.0349 -55.8537 -50.7646 50.0035 -164 3 45.375 10.2125 35.7599 43.422 25.9365 -4.74067 -165 4 43.1984 6.94617 35.4338 19.599 0.647333 4.29925 -166 4 44.1406 8.86955 34.0842 9.16679 3.97336 -28.1373 -167 4 42.9197 9.91228 34.8204 -18.5221 19.1219 -12.9063 -168 1 44.2798 8.93745 37.3587 -4.0043 10.1489 -58.0949 -169 2 45.1948 9.27519 38.4238 -4.17993 36.3676 -26.0855 -170 2 46.5575 8.73344 38.0061 12.5522 -20.4469 18.6928 -171 3 46.7331 7.49794 37.7681 -6.88831 31.8582 -6.20611 -172 4 43.377 8.45873 37.5311 9.37776 2.67644 11.4724 -173 4 45.2318 10.4158 38.3238 5.33405 -13.6354 14.6161 -174 2 44.7823 8.84756 39.8415 35.39 -32.4267 -9.44324 -175 2 45.5211 9.64049 40.9405 -33.0234 -16.4934 27.578 -176 2 45.0293 11.1067 41.0295 26.955 13.1382 1.75579 -177 2 45.9939 11.883 0.056845 5.44769 -3.52142 -7.77113 -178 1 45.567 13.2463 0.389189 -21.8942 22.5552 58.7427 -179 4 44.9649 7.71121 39.9163 -1.68078 22.7299 4.94117 -180 4 43.7292 8.96914 40.0006 -34.3585 3.91778 0.788359 -181 4 46.6326 9.56148 40.8729 -4.12637 -0.755434 -1.7729 -182 4 45.1589 9.15652 0.052119 21.5355 9.01144 -26.2886 -183 4 44.0384 11.1525 41.4882 -17.6691 -1.8484 1.78047 -184 4 44.9645 11.6456 40.0488 1.32443 -5.52779 3.51863 -185 4 46.9936 12.0079 41.4163 -11.0521 -7.71607 17.8496 -186 4 46.0863 11.2417 1.01939 6.64185 25.7549 -16.0759 -187 4 45.6176 13.9315 41.5535 6.39074 -1.54943 -2.93714 -188 4 46.1207 13.6426 1.21669 -15.3499 -18.2055 -38.2327 -189 4 44.572 13.3465 0.725918 28.6554 -12.4083 -12.8179 -190 1 47.5723 9.62675 38.0225 1.62241 16.525 -13.2778 -191 2 48.9413 9.31976 37.6447 28.3505 6.17866 3.85392 -192 2 49.7947 9.65595 38.897 -51.2415 76.6103 -24.0977 -193 3 49.6063 10.7902 39.4401 12.9093 -42.4425 -12.577 -194 4 47.4538 10.6389 38.3066 -1.81401 -22.4625 -4.08398 -195 4 49.0905 8.23756 37.4201 -8.03606 -0.867672 -0.903629 -196 2 49.3577 10.1392 36.3514 -15.5639 -8.86216 -34.5575 -197 3 48.3381 9.84531 35.2995 20.2521 4.60838 26.9691 -198 2 50.6821 9.73379 35.6575 -13.1705 -1.52152 26.2758 -199 4 49.443 11.2403 36.5183 -14.2645 -0.263993 8.70321 -200 4 47.5106 10.2398 35.5579 0.218555 2.62212 3.26783 -201 4 50.9323 10.3465 34.7687 -2.88514 -3.55444 -7.60949 -202 4 50.7732 8.65192 35.4951 -3.14548 -9.24106 -12.1943 -203 4 51.4763 9.94768 36.3674 17.1427 5.0591 10.0517 -204 1 50.5022 8.69828 39.4305 24.0939 -43.466 77.1583 -205 2 51.0483 8.71922 40.8082 -0.802123 10.2433 -32.8315 -206 2 52.5183 8.33859 40.7231 46.1376 25.1574 58.8821 -207 3 52.8914 7.33748 40.1143 13.0446 10.4001 -14.6089 -208 4 50.6189 7.73433 39.1341 -5.48208 -8.91176 -29.3848 -209 4 51.0045 9.75097 41.1725 -0.547397 17.2241 4.09797 -210 2 50.2922 7.85282 41.8455 19.6626 -50.7873 -7.63422 -211 2 50.2811 6.29504 41.471 -17.2864 -17.6708 26.7503 -212 2 48.8668 8.31684 0.212195 -17.3783 63.506 12.4232 -213 2 49.3691 5.38294 0.512646 14.3884 65.6628 -4.02696 -214 4 50.9326 7.9114 0.860642 -12.3241 5.1929 3.57402 -215 4 51.3127 5.83882 41.5287 -4.74499 10.5855 -5.5164 -216 4 49.8921 6.13652 40.4532 1.6457 0.843055 -11.9856 -217 4 48.0317 8.06123 41.424 13.0217 -7.20036 -2.54126 -218 4 48.8693 9.49201 0.254246 -0.917701 -32.4673 -2.46528 -219 4 48.5263 8.05212 1.23597 1.41612 -6.96817 -0.649274 -220 4 48.2816 5.57755 0.309314 6.34191 -1.32326 5.14384 -221 4 49.6363 5.72968 1.56057 -11.1106 -15.1353 -5.99489 -222 4 49.54 4.32324 0.397743 7.27301 -24.1582 -2.3836 -223 1 53.3925 9.14738 41.5454 -19.7766 -15.6836 -47.6014 -224 2 54.8543 9.29866 41.641 -12.5045 -20.0873 29.727 -225 2 0.407838 8.25913 0.762984 -29.7207 32.5524 -37.8245 -226 3 54.8643 8.2564 1.86493 17.0269 -29.0845 20.332 -227 4 52.9285 9.69819 0.341812 -9.11605 14.2566 13.2302 -228 4 0.291486 9.0623 40.6877 9.99865 -5.39191 -34.8298 -229 2 0.359683 10.7121 0.203065 -6.90664 -3.88067 -14.6485 -230 3 54.4765 11.8025 41.752 -11.2022 -21.2627 -5.88002 -231 2 1.6614 11.1001 41.4135 2.5167 -27.9916 -13.3179 -232 4 0.487415 10.6137 1.28953 0.410521 18.1219 13.0764 -233 4 54.0953 12.1937 0.613553 1.59003 1.59721 11.7532 -234 4 1.92456 12.0955 41.7398 14.8193 23.7252 4.53742 -235 4 1.52762 11.126 40.2979 3.61624 1.93597 7.36374 -236 4 2.5241 10.4069 41.6364 -8.38015 7.04993 1.52106 -237 1 1.45864 7.53391 0.367476 0.545631 9.71791 -21.8799 -238 2 2.25081 6.65311 1.15507 26.446 -0.0641839 -18.4938 -239 2 3.7671 6.96757 0.917085 -57.4365 -22.4689 85.9929 -240 3 4.15047 7.41488 41.7757 21.4144 12.1214 -29.7802 -241 4 1.8001 7.62601 41.3064 3.76941 -0.348546 3.21752 -242 4 1.98413 6.84865 2.19976 1.77378 -4.57114 13.3572 -243 2 1.98593 5.20856 0.673411 -39.0557 8.05152 -2.47083 -244 2 0.499001 4.77546 0.950638 51.92 -35.3278 3.54994 -245 2 0.302449 3.38226 0.307039 12.2804 5.92691 27.6936 -246 2 0.318833 4.59091 2.46762 -57.1886 17.9845 23.4913 -247 4 2.62035 4.47984 1.15306 24.0478 -12.5257 10.4353 -248 4 2.17019 5.14075 41.4887 6.74012 -0.473312 -2.7006 -249 4 54.8482 5.46061 0.448133 -33.0903 28.7369 -7.07308 -250 4 54.2241 3.15851 0.337643 -14.6094 -12.7265 -2.24176 -251 4 0.881511 2.58656 0.876485 -8.96903 11.0382 -11.5819 -252 4 0.635114 3.38296 41.1822 2.70741 -4.49002 -20.1461 -253 4 0.991181 3.80938 2.86091 2.53728 -4.51346 7.06316 -254 4 54.1796 4.30541 2.72425 38.6722 3.44969 -10.622 -255 4 0.495432 5.52724 3.08531 2.73328 -11.7655 -13.2166 -256 1 4.49387 6.66874 2.05101 59.25 35.5651 -63.8633 -257 2 5.97745 6.82619 2.08157 -13.5783 -40.6566 -15.6714 -258 2 6.57448 5.47381 2.54294 67.6927 12.9151 50.3283 -259 3 7.53922 5.43765 3.33186 -5.78511 6.85237 -12.8739 -260 4 4.10191 6.33546 2.9164 -11.2688 -10.0369 11.6191 -261 4 6.35409 6.85375 1.02753 1.73229 12.3732 3.55997 -262 2 6.47001 8.00523 2.96248 -35.1701 -2.47648 -9.01657 -263 2 6.52316 9.38515 2.26526 -52.089 -36.3571 -52.5381 -264 2 6.66039 10.5311 3.17647 23.2175 30.5211 32.7092 -265 3 7.81872 10.9467 3.49478 5.10838 -9.19539 -6.96115 -266 3 5.64173 11.0573 3.6767 -20.5888 -1.64097 0.158765 -267 4 7.42654 7.87231 3.41702 35.4584 -16.2138 5.63399 -268 4 5.81838 7.86205 3.84167 -4.54492 27.3919 10.2645 -269 4 5.56237 9.49095 1.59664 20.5708 1.89307 25.306 -270 4 7.29681 9.38215 1.47849 13.2355 1.21078 1.19218 -271 1 6.08096 4.31767 2.17259 -39.414 -15.8224 -24.7678 -272 2 6.39518 2.91476 2.36043 4.12081 37.0723 19.1814 -273 2 7.75633 2.62628 1.79624 63.8838 -9.4865 -25.3011 -274 3 8.33634 3.36937 0.946953 -27.4154 -16.213 26.3787 -275 4 5.28658 4.43126 1.58002 -24.0887 -1.16266 -20.2566 -276 4 6.54455 2.77577 3.45017 -8.86613 -5.70482 8.60941 -277 2 5.25427 2.02933 1.82805 -30.6144 -48.6247 5.61864 -278 2 3.85552 2.1153 2.66383 78.486 27.413 32.1434 -279 2 4.87851 2.27508 0.297641 -10.4566 -15.7718 22.2154 -280 4 5.65998 0.937168 1.99721 -15.6319 23.5495 -14.0675 -281 4 3.98898 1.63213 3.72107 -1.04911 23.3354 -24.3429 -282 4 3.15409 1.48884 2.20213 -45.477 -24.0418 -26.2275 -283 4 3.51802 3.20813 2.70746 -2.40249 -20.6527 6.6832 -284 4 4.39172 3.24426 0.119355 -1.44384 9.21297 0.0772101 -285 4 4.19746 1.51559 41.6955 12.4172 8.09212 16.5491 -286 4 5.82002 2.28129 41.6778 17.5327 1.3005 -22.4945 -287 1 8.43941 1.53208 2.30673 1.7292 42.4201 -39.4356 -288 2 9.76672 1.10452 1.81012 11.995 -19.5667 23.3003 -289 2 9.60964 41.7637 0.921245 4.05677 21.7498 -11.1929 -290 3 8.59567 41.087 1.06007 7.18507 -15.5872 -8.58634 -291 4 7.90606 0.81761 2.76924 -8.42032 -19.931 16.3865 -292 4 10.4026 1.87877 1.34085 -18.5158 15.1062 -12.7744 -293 2 10.6232 0.647963 3.0246 -34.7832 -39.5023 14.4787 -294 2 11.0993 1.6812 4.04079 16.2934 16.5377 23.708 -295 2 12.4719 2.27616 3.59128 -46.8378 -2.52013 6.7155 -296 3 13.4675 1.63575 4.02276 22.0629 14.477 -13.463 -297 3 12.4471 3.24187 2.73298 15.8946 -22.2661 28.0778 -298 4 11.4641 0.045385 2.63277 10.8271 5.92943 5.75519 -299 4 10.0353 41.7446 3.607 8.35649 20.5438 -12.0897 -300 4 11.2832 1.11765 5.0427 -4.51453 13.9694 -21.6118 -301 4 10.341 2.4932 4.3105 9.65416 -13.2167 -8.7997 -302 1 10.6494 41.4676 0.039711 8.78515 0.440053 18.9323 -303 2 10.7217 40.2184 41.1909 10.2574 -28.5822 12.1248 -304 2 10.6889 38.8907 0.171469 -17.3791 70.2346 -13.2363 -305 3 10.1368 37.8928 41.652 0.864281 -20.5458 12.6113 -306 4 9.82473 40.2067 40.5786 -14.2689 -8.84554 -18.4029 -307 2 12.0478 40.1799 40.3262 -31.3786 20.6535 10.6233 -308 2 12.4388 41.6551 40.4794 16.223 20.8678 -10.392 -309 2 11.8805 0.34241 41.7792 -28.1233 -36.7072 -34.4959 -310 4 11.9102 39.8982 39.2292 -1.08614 0.893428 17.4874 -311 4 12.7409 39.4563 40.8087 9.93344 3.46544 -3.32375 -312 4 12.0845 0.391154 39.5895 8.62314 -16.2997 14.2071 -313 4 13.5502 41.7447 40.5643 -1.70925 0.910467 -12.4735 -314 4 11.7305 1.40344 41.6414 -9.5626 24.5309 -2.35213 -315 4 12.5687 0.26268 0.684216 19.8182 -9.73862 27.9097 -316 1 11.1854 39.0885 1.40191 34.1901 -11.3327 18.3686 -317 2 11.4785 38.09 2.41707 -37.5808 13.2867 4.32174 -318 2 10.2405 37.7763 3.3402 -0.155099 -13.1844 6.87934 -319 3 10.4378 36.9653 4.27207 -11.6928 9.67513 -22.7546 -320 4 11.6756 39.9703 1.62918 -8.97807 -2.58442 -2.36164 -321 4 11.7153 37.147 1.89269 -3.37493 -11.1801 -2.58831 -322 2 12.7263 38.4682 3.25859 -32.7454 -15.529 27.3397 -323 3 12.5885 39.7408 3.87129 1.54426 18.5893 -11.5354 -324 4 13.5945 38.4441 2.61946 23.9879 5.88222 -14.7576 -325 4 12.9197 37.685 4.04183 -3.566 10.9198 -2.82194 -326 4 11.9285 39.8531 4.57214 8.5625 -16.1459 -5.7164 -327 1 8.98961 38.3717 3.14779 19.3135 28.1448 -76.0315 -328 2 7.78009 38.1002 3.90315 -4.26896 22.0341 0.229441 -329 2 6.83069 37.1869 3.18241 -25.8564 -25.3069 -16.1867 -330 3 6.84398 36.9785 1.97125 20.9058 23.903 -13.4458 -331 4 8.79049 38.9506 2.20714 10.5577 -30.8167 54.9659 -332 4 8.11274 37.5073 4.75427 1.14536 -6.32615 23.8911 -333 2 7.0077 39.4163 4.32571 4.21253 -4.87986 18.678 -334 2 7.75781 40.1168 5.42156 46.58 -14.1846 12.934 -335 3 8.30143 41.2262 5.21331 -14.6188 11.6514 -5.86083 -336 3 8.10545 39.4797 6.46784 -18.045 3.20128 -4.6129 -337 4 6.01572 39.173 4.78754 -1.72287 0.045533 -10.2864 -338 4 6.87032 40.2048 3.55457 -4.98407 -10.6589 -12.5629 -339 1 5.91154 36.4899 3.88964 18.6928 -0.691686 25.3425 -340 2 4.98537 35.571 3.20749 -24.0931 31.8814 30.8723 -341 2 3.79198 36.4499 2.67545 58.5623 50.3783 54.6165 -342 3 3.60244 37.6478 3.05835 4.98938 -42.2114 -12.2812 -343 4 5.945 36.5545 4.93654 -10.5756 -4.83423 -16.3239 -344 4 5.5221 35.038 2.40161 -3.05594 2.46612 -11.4716 -345 2 4.40384 34.4728 4.15145 -1.70261 45.9252 5.92389 -346 3 3.98498 35.0725 5.41787 -8.00202 -46.5665 -16.5053 -347 2 5.48475 33.4747 4.46048 0.249803 -29.9924 71.6177 -348 4 3.54337 34.0389 3.61058 -6.82183 -12.9435 7.69028 -349 4 3.62675 34.2747 5.86698 6.39679 27.749 2.05336 -350 4 5.85279 32.9868 3.57629 11.3184 -16.9973 -22.3871 -351 4 5.09248 32.6743 5.23041 8.97186 17.4623 -32.7541 -352 4 6.34746 33.9006 5.03324 -0.476546 4.78606 -11.5797 -353 1 3.00152 35.8184 1.87366 -46.1462 -42.5584 -55.0681 -354 2 1.77021 36.3468 1.35692 -36.7765 14.163 11.1031 -355 2 0.721356 36.5788 2.57059 18.2386 -29.7925 23.2574 -356 3 54.9678 37.5551 2.63992 10.9193 3.0322 -8.68025 -357 4 3.31287 34.9586 1.40066 1.19836 -3.77239 4.28893 -358 4 2.05059 37.3327 0.922928 -11.4048 10.7741 9.22697 -359 2 1.07197 35.5705 0.158527 41.3495 -39.9506 -9.05678 -360 2 1.73776 35.9497 40.6674 -26.4234 39.8053 33.0301 -361 2 54.5322 35.7209 0.133627 -14.8072 -12.0564 -1.20894 -362 2 3.23928 35.9487 40.63 7.11928 -24.1756 -12.68 -363 4 1.32474 34.4514 0.269568 -7.211 20.0201 5.35532 -364 4 1.47926 37.0502 40.6385 -3.87579 -7.90549 -26.2729 -365 4 1.36122 35.3789 39.7771 -4.72819 3.84386 12.155 -366 4 54.087 35.0558 41.2526 3.68912 7.63158 3.17282 -367 4 54.2076 36.7772 41.8385 0.949253 -6.55132 4.09096 -368 4 54.0676 35.3362 1.10912 4.22691 12.456 -17.368 -369 4 3.57003 34.9443 40.8434 9.13412 -24.8126 8.40569 -370 4 3.78301 36.5792 41.3142 5.34684 18.5101 18.1918 -371 4 3.6567 36.127 39.6372 -0.20476 7.44967 -14.9904 -372 1 0.712989 35.6055 3.58431 38.0557 9.26554 -59.6495 -373 2 0.05279 35.6483 4.83915 -15.0961 2.42646 38.658 -374 2 0.191347 37.0144 5.48801 7.00468 33.8104 1.40802 -375 3 54.154 37.7008 5.76148 35.4113 -11.6645 -8.2681 -376 4 1.23482 34.733 3.35856 -11.2418 4.01634 10.8504 -377 4 53.9671 35.581 4.69172 -20.2496 -5.13772 -12.456 -378 2 0.463881 34.4895 5.81355 17.031 15.9659 -33.5139 -379 2 54.8083 34.3393 7.16558 -30.7527 -16.2072 -11.1445 -380 2 0.00712 35.4957 8.10271 3.59003 -8.69902 15.3198 -381 3 54.0967 36.3529 8.34542 -1.77732 -9.94333 -12.6544 -382 3 1.07192 35.4587 8.7399 35.3598 16.353 18.5034 -383 4 1.56574 34.5304 5.94519 0.590681 0.639559 4.32925 -384 4 0.280894 33.5741 5.23349 -1.52963 -16.3279 0.16603 -385 4 0.223173 33.3947 7.64873 -6.8885 8.42796 -3.46601 -386 4 53.7112 34.1554 6.97481 9.65493 -2.46487 7.60139 -387 1 1.50649 37.4152 5.65526 -22.458 -31.2308 -17.0045 -388 2 2.02438 38.6379 6.15097 -3.22056 29.1656 36.4104 -389 2 1.58588 39.8651 5.40701 -13.5031 20.9194 -76.104 -390 3 1.07209 40.8553 5.93778 8.03965 -15.1327 11.1864 -391 4 2.24702 36.741 5.38136 -6.00826 1.88497 2.51587 -392 4 1.72629 38.833 7.20228 -22.1923 -11.9073 0.0585309 -393 2 3.51949 38.6121 6.24971 43.6984 -50.5664 -0.0787057 -394 2 4.11017 39.7004 7.10642 -5.48661 12.2779 -12.8977 -395 3 4.55887 40.7033 6.57435 6.12607 11.2234 -5.55098 -396 1 3.97545 39.5562 8.42942 -13.6958 7.00999 41.6346 -397 4 3.92653 38.5973 5.19958 6.67843 9.43594 11.2804 -398 4 3.90699 37.6191 6.72902 -10.8805 23.4385 -12.7616 -399 4 3.35162 38.8096 8.83526 13.2612 9.60447 -6.60232 -400 4 4.25023 40.3377 9.09595 -2.56729 -20.1743 -21.9158 -401 1 1.64621 39.8034 3.99517 -50.1719 52.4074 67.8966 -402 2 0.960547 40.8538 3.14427 -3.37695 -31.9032 -17.009 -403 2 54.4047 41.0035 3.47138 71.1401 19.2662 2.3079 -404 3 53.9887 0.221409 3.63964 -22.8765 18.4333 9.81455 -405 4 2.07659 38.9926 3.63308 18.9969 -31.9912 -34.7926 -406 4 1.39808 41.8727 3.34889 0.835518 -9.01277 1.27119 -407 2 1.14841 40.4887 1.56595 -9.49555 20.2148 39.7014 -408 2 0.469253 41.6189 0.677094 10.8075 11.2475 47.495 -409 2 2.6528 40.4777 1.25625 -15.459 -47.3647 -39.6369 -410 4 0.776571 39.4398 1.40308 -11.1955 11.1351 -6.38222 -411 4 54.3852 41.8501 0.825468 -5.0709 -17.7069 -2.05205 -412 4 0.696071 41.5065 41.5456 0.0730393 -4.82529 -32.9133 -413 4 0.904174 0.691668 0.985463 6.30616 -9.41897 -5.2369 -414 4 2.64269 40.3122 0.13166 16.7998 18.1471 15.5753 -415 4 3.13789 39.5289 1.58622 -1.56816 4.1145 9.56394 -416 4 3.29805 41.2779 1.59825 6.1243 20.9887 1.16769 -417 1 53.684 39.9214 3.65257 -36.1976 13.6917 8.19643 -418 2 52.3006 39.9493 4.06589 -56.8626 -17.5359 -10.0305 -419 2 52.042 40.5256 5.46425 9.62461 10.2848 -5.14962 -420 3 51.0331 41.2228 5.70144 14.4944 -11.372 -4.23176 -421 4 54.0189 39.0607 3.30247 15.8062 -40.5534 -6.95561 -422 4 51.6931 40.6476 3.38276 19.0563 -8.07776 7.22418 -423 2 51.5622 38.4976 3.96193 14.5706 2.1127 21.5154 -424 2 51.4158 37.9814 2.50572 24.752 -20.928 -15.9835 -425 2 51.0077 36.4305 2.37064 11.3099 30.9145 9.08043 -426 2 50.8522 35.9939 0.907307 -46.4939 -7.09254 -49.7464 -427 1 50.1475 34.7025 0.671588 69.6077 -32.405 2.84717 -428 4 50.6006 38.4842 4.55016 3.73478 6.81079 -18.2086 -429 4 52.1831 37.7463 4.55262 -3.81101 12.3643 -13.1539 -430 4 52.4118 38.1657 2.02278 1.77015 -18.5404 7.48984 -431 4 50.8584 38.5927 1.79489 -26.3581 9.74254 8.34414 -432 4 50.0453 36.2246 2.88499 -2.56193 3.57961 3.68626 -433 4 51.7703 35.8375 2.92238 0.215708 -6.73604 -5.33103 -434 4 51.7691 36.0437 0.240386 -6.2594 -4.10885 19.6388 -435 4 50.1039 36.686 0.3716 22.9763 1.60597 16.3794 -436 4 50.5914 33.8993 1.10828 2.95648 12.8391 18.7814 -437 4 50.3001 34.3737 41.6268 -19.3387 19.3411 -4.27099 -438 4 49.2006 34.6111 0.961468 -24.084 7.88088 -0.582308 -439 1 53.0235 40.2561 6.35237 -32.3128 10.4579 -5.0201 -440 2 53.1129 40.7256 7.70074 -41.6363 -1.15369 57.3167 -441 2 53.1798 0.352689 7.77253 -34.9991 -20.8035 37.2736 -442 3 52.5119 1.01286 8.63006 21.7579 -17.6925 -30.8538 -443 4 53.6931 39.5673 6.06584 22.7894 -18.2937 1.39271 -444 4 52.0865 40.4844 8.3065 35.7608 3.68212 -29.1988 -445 2 54.2701 40.0034 8.46069 6.08948 28.5921 -6.02695 -446 4 54.5971 40.5153 9.39975 -22.234 -14.34 10.1754 -447 4 0.201561 40.2092 7.93116 13.6903 -2.08726 -21.3806 -448 4 54.1655 38.8939 8.41526 -0.559105 0.118215 15.5404 -449 1 53.9752 0.884949 6.87383 32.3465 35.364 -24.1241 -450 2 54.062 2.35993 6.75215 -1.13821 -0.709889 -34.8218 -451 2 52.7471 3.02097 6.14186 4.92946 35.4069 59.7439 -452 3 52.3227 4.16587 6.4978 18.9545 -33.4145 3.00952 -453 4 54.7345 0.266534 6.4753 -18.8262 24.4346 -1.05702 -454 4 54.2802 2.76759 7.79054 -12.1814 3.84369 -14.3249 -455 2 0.185451 2.81859 5.73187 27.2059 46.9588 30.4236 -456 2 1.71808 2.36893 6.1571 -63.9259 -20.0653 -29.4315 -457 2 1.9764 2.63004 7.63437 43.6306 13.7343 2.97159 -458 2 3.27263 1.81187 8.04275 -33.9139 -3.58936 -6.58926 -459 1 3.78328 2.11956 9.34176 26.6398 21.4152 24.507 -460 4 0.173809 4.01773 5.82442 4.54198 -39.0295 -6.50933 -461 4 54.8792 2.64498 4.65574 11.0791 -10.5686 10.592 -462 4 2.43618 2.90609 5.45978 -2.35628 -10.1976 10.4282 -463 4 1.76796 1.2289 6.01344 4.57023 21.5888 -8.89179 -464 4 1.21473 2.41369 8.37281 -19.449 -19.8593 5.28327 -465 4 2.02309 3.72579 7.75906 18.9296 5.96095 -1.30777 -466 4 4.11389 1.88412 7.33652 2.51142 0.584915 -8.00636 -467 4 2.91513 0.727469 8.06593 14.1612 11.4678 0.952909 -468 4 3.87966 1.33238 9.93849 2.65093 -23.7146 9.43734 -469 4 3.29203 2.7681 9.89323 -42.3935 13.6729 9.41431 -470 4 4.65765 2.6209 9.4154 12.4458 -11.5538 -21.8273 -471 1 52.0387 2.32512 5.28273 -51.3661 -11.8477 -11.6622 -472 2 50.6641 2.72274 4.84157 25.7857 6.93126 13.1254 -473 2 49.5414 2.57609 5.91007 27.6149 -7.37739 5.45836 -474 3 48.7805 3.52104 6.09585 -8.9672 -1.93713 4.87304 -475 4 52.4681 1.55108 4.79165 6.19099 -18.5603 -5.58783 -476 4 50.6769 3.82983 4.70864 1.41274 -1.50214 -10.3294 -477 2 50.3587 2.05695 3.49156 -22.4167 -18.5545 -8.10533 -478 2 51.392 2.35646 2.3419 -24.5199 12.8001 2.40788 -479 2 48.9327 2.41504 2.97856 -9.14079 -2.86031 26.3031 -480 2 51.1945 1.4129 1.15651 29.522 -13.6455 -15.5517 -481 4 50.3189 0.937191 3.7523 9.08136 15.4094 -11.3523 -482 4 52.3823 2.12188 2.68097 31.5971 -0.36407 15.4796 -483 4 51.4014 3.46798 2.06765 -1.078 -19.9026 -0.0406259 -484 4 48.2117 2.12758 3.78451 -1.04241 22.2186 2.00084 -485 4 48.5813 1.67256 2.28636 2.21501 -12.0529 -35.8697 -486 4 48.7327 3.44552 2.54328 5.48386 -12.5705 11.3103 -487 4 52.1623 1.3706 0.452926 -36.5132 5.61179 20.4585 -488 4 50.2881 1.70969 0.600596 -1.11419 -0.409473 -10.6314 -489 4 51.0211 0.353877 1.53511 3.53067 13.7442 -8.50616 -490 1 49.5623 1.51743 6.77214 29.0905 -0.0770965 -25.5222 -491 2 48.7084 1.41716 7.91723 -3.12505 -21.6463 4.96918 -492 2 48.8549 2.61932 8.82546 31.903 20.2748 29.0475 -493 3 47.906 3.05048 9.46897 -16.8524 2.35798 -10.3438 -494 4 50.2118 0.710522 6.59294 -12.9921 18.0739 4.61122 -495 4 47.6425 1.393 7.52359 9.91609 0.328738 10.372 -496 2 49.0787 0.089334 8.73016 -60.0302 -9.6098 -44.8862 -497 2 48.2852 41.7441 10.0242 3.18066 15.7764 -9.96769 -498 2 46.7826 0.060746 9.96682 -2.34726 -14.6607 41.7592 -499 3 46.2233 0.511631 10.9878 -5.96974 4.10403 -23.4495 -500 1 46.1388 41.3329 8.97776 32.9533 20.065 15.0282 -501 4 50.1182 0.035639 8.93296 42.8084 2.68407 12.3764 -502 4 48.8904 41.1121 8.0025 3.88899 17.9501 19.4277 -503 4 48.6104 0.602172 10.7954 4.73737 -18.8132 -0.914642 -504 4 48.4759 40.6816 10.3394 0.165969 9.19265 10.3013 -505 4 46.673 40.8953 8.25882 14.2049 -15.3063 -26.5369 -506 4 45.1569 41.364 8.91958 -49.0994 -2.53611 0.320683 -507 1 50.1114 3.13932 9.06291 -28.12 32.8195 0.337886 -508 2 50.3404 4.32895 9.98795 -1.65029 -57.226 -17.8628 -509 2 50.0322 5.66893 9.41362 -36.2334 -9.83443 -38.9072 -510 3 49.3598 6.44562 10.1062 15.3309 6.40082 -5.38514 -511 4 50.9085 2.84633 8.5071 12.3092 -10.0263 -3.45928 -512 4 49.5835 4.28149 10.7848 -3.38143 -13.253 14.1405 -513 2 51.7461 4.22789 10.5468 25.7206 14.4209 20.1557 -514 2 51.9023 5.17188 11.7283 -67.9962 -1.36338 64.1829 -515 3 50.9364 5.19004 12.6002 28.9599 1.18541 -41.9912 -516 3 52.9319 5.83594 11.9785 18.8411 2.87417 -24.5577 -517 4 52.4276 4.5214 9.72474 12.6887 -3.13287 0.413374 -518 4 52.058 3.21563 10.9647 -9.24198 7.66389 -16.6414 -519 1 50.112 5.78532 8.03139 7.52033 29.602 25.459 -520 2 49.6799 7.08933 7.40639 14.3534 -30.8181 22.5674 -521 2 48.2409 7.17209 6.9711 -2.24553 44.7474 7.57528 -522 3 47.5844 8.22961 7.08968 18.1939 -9.81929 5.41459 -523 4 50.7064 5.09112 7.53173 -12.638 14.3936 -6.22521 -524 4 49.7159 7.84119 8.19837 -7.36252 7.51614 21.2329 -525 2 50.7023 7.64954 6.44039 -16.0213 -40.4967 -48.4302 -526 2 50.7257 6.82423 5.08423 -13.7427 47.9405 2.4816 -527 2 51.6418 7.28287 3.94021 29.8472 39.248 73.299 -528 2 53.127 6.98483 4.24688 1.29977 19.7271 -18.9866 -529 1 53.757 7.95176 5.17575 -11.1866 13.844 -62.5277 -530 4 51.636 7.68275 6.97838 28.3767 1.23741 1.58475 -531 4 50.4129 8.66535 6.18803 -0.179632 23.7408 -3.11047 -532 4 49.7187 7.01043 4.64523 -5.97611 -10.1095 1.48316 -533 4 50.8061 5.7562 5.2149 3.4405 -22.8364 10.0865 -534 4 51.5118 8.41472 3.72654 -1.36136 -26.6124 -3.74792 -535 4 51.4228 6.66542 3.12568 -20.7249 -22.8033 -58.4365 -536 4 53.6095 7.03345 3.2004 3.85152 5.93338 28.8514 -537 4 53.3314 5.96083 4.57939 -0.112253 -9.13532 8.29834 -538 4 53.309 8.86524 5.1699 0.162268 -2.42959 1.84412 -539 4 54.6672 8.17057 4.81193 19.2107 -0.812718 7.6593 -540 4 53.869 7.69009 6.11536 0.991087 -15.435 33.6166 -541 1 47.7293 6.1299 6.36528 -13.6545 -50.1986 -45.913 -542 2 46.4151 6.11998 5.73127 12.5517 -4.35851 26.1033 -543 2 45.4457 5.24236 6.50095 -54.5114 -4.35957 -22.3583 -544 3 44.2134 5.34166 6.22856 33.5613 3.36987 15.344 -545 4 48.2957 5.29705 6.08439 -4.65701 16.0313 11.2062 -546 4 46.0246 7.14829 5.83676 -12.413 4.85954 -1.2939 -547 2 46.3966 5.7006 4.23247 16.9743 -35.0719 19.3242 -548 2 46.8471 6.79722 3.31369 7.95245 13.9142 -51.9109 -549 2 46.0679 8.12855 3.29075 19.7668 12.2354 20.4517 -550 3 44.9703 8.28242 2.6836 -5.20426 -7.76074 -7.99938 -551 3 46.5716 9.08042 3.9624 -5.49585 -3.27174 -8.75295 -552 4 45.3525 5.37075 3.98324 7.30106 1.55378 -6.68576 -553 4 47.1483 4.79199 4.10624 -28.8106 21.423 0.303262 -554 4 47.0017 6.41037 2.24023 -12.0684 6.13088 18.9752 -555 4 47.8815 7.05675 3.60692 6.175 4.12296 2.89493 -556 1 45.8802 4.28795 7.34048 -32.7588 9.8199 -6.22093 -557 2 44.9801 3.41661 8.05582 7.11941 -0.762777 6.83491 -558 2 44.2841 2.32798 7.24802 57.2007 25.2815 -35.4523 -559 3 43.4338 1.62321 7.71908 -38.784 -24.7635 26.1598 -560 4 46.8556 4.13399 7.46211 34.7056 -9.13536 7.69054 -561 4 45.5867 2.90913 8.82837 -2.10841 -5.06197 5.41207 -562 4 44.2233 4.00883 8.63057 1.71074 -0.990438 -6.10924 -563 1 44.7516 2.08483 5.98824 -37.8462 -38.4135 -8.16449 -564 2 44.1597 1.01431 5.13579 -9.65639 -34.378 14.28 -565 2 44.8664 41.5016 5.49089 -11.1964 37.9598 3.64882 -566 3 46.103 41.4369 5.57345 -11.1149 2.47206 2.88353 -567 4 45.5262 2.474 5.47152 21.0389 22.2918 12.8005 -568 4 43.0172 0.862184 5.40503 31.5022 14.6416 -15.142 -569 2 44.4162 1.4085 3.60515 5.8653 -21.2021 14.2009 -570 2 43.5161 2.65984 3.27425 41.0117 -18.0627 24.5931 -571 2 44.2213 0.116838 2.67583 -30.001 3.65408 12.6342 -572 2 43.604 3.10049 1.82796 -41.0466 14.5447 22.3036 -573 4 45.4923 1.71966 3.57573 -0.138156 -3.02814 -11.6903 -574 4 43.8008 3.50537 3.97163 -2.46499 -4.10631 -11.566 -575 4 42.524 2.38704 3.60859 -29.3388 -0.685173 -5.23931 -576 4 44.5714 0.285197 1.65031 -2.2735 9.46305 -11.1841 -577 4 43.1006 41.7553 2.65834 21.2852 6.7215 -5.00379 -578 4 44.7366 41.0658 2.93547 0.768749 11.7185 9.28335 -579 4 44.5004 3.68719 1.60884 14.6444 -0.878149 -7.94907 -580 4 42.7371 3.8089 1.73084 7.8177 -0.664582 -10.9353 -581 4 43.3892 2.25631 1.16493 5.07933 -5.28874 -15.8541 -582 1 44.0858 40.4147 5.76991 -7.82686 10.7063 0.0613705 -583 2 44.6952 39.2248 6.26612 46.8291 -49.1328 2.55503 -584 2 45.6273 38.4983 5.15014 -10.8203 -24.5871 -10.3389 -585 3 45.1671 38.1033 4.04814 1.93862 22.6196 32.2907 -586 4 45.3114 39.4262 7.20071 -5.62912 7.00222 -16.0196 -587 2 43.5561 38.2867 6.74046 -22.632 -0.869913 -14.9675 -588 2 42.367 38.8131 5.80069 8.99216 14.1028 58.1483 -589 2 42.6345 40.3137 5.92605 0.476166 33.3948 28.8915 -590 4 43.357 38.4284 7.8368 -6.62566 13.9326 -12.0425 -591 4 43.8048 37.1922 6.7609 -3.60965 9.48681 -21.6917 -592 4 41.3136 38.6254 6.13023 8.266 -9.51845 1.65532 -593 4 42.4187 38.6156 4.74928 6.70678 -23.3061 -29.6074 -594 4 42.2773 40.816 6.98347 15.1971 -23.3227 -46.4987 -595 4 42.1119 40.8277 5.08767 -3.55372 4.4917 2.49103 -596 1 46.8487 37.9967 5.55394 17.2019 12.2692 25.006 -597 2 47.7247 37.0178 4.87762 -6.21972 -16.2302 -28.9734 -598 2 47.0354 35.8358 4.10675 -5.54108 30.4574 49.2069 -599 3 47.4638 35.4602 3.01706 -3.2731 6.26074 0.626287 -600 4 48.411 37.4477 4.12082 -11.0175 18.1135 -5.68521 -601 2 48.6499 36.5231 5.98749 -16.6595 -15.0747 15.7963 -602 2 48.891 37.7945 6.79307 0.637735 -25.9659 35.4869 -603 2 47.512 38.4108 6.81936 -6.06228 0.364124 -35.7901 -604 4 49.55 36.0027 5.64818 14.2665 0.926908 -8.4052 -605 4 48.1323 35.7432 6.6035 -1.04051 5.39171 0.916503 -606 4 49.6303 38.4539 6.33816 11.9938 9.28906 -4.17289 -607 4 49.2156 37.5316 7.87598 -0.828426 8.45001 -24.626 -608 4 47.6223 39.5002 6.92189 -5.61966 10.135 -2.25063 -609 4 46.9349 38.0418 7.65693 -11.0214 -6.34351 22.8142 -610 1 45.9811 35.3016 4.79343 19.1712 31.3513 11.165 -611 2 45.3118 34.1769 4.28537 -21.2148 -46.3229 -17.5718 -612 2 44.4751 34.4561 3.06273 -18.3812 8.00009 -33.6438 -613 3 44.391 33.6426 2.09905 3.94034 16.0457 30.0851 -614 4 45.6176 35.6832 5.71813 13.2063 -8.66839 -22.6288 -615 4 46.0373 33.4799 3.80083 11.0255 -0.404913 12.3267 -616 2 44.604 33.4055 5.40679 37.9095 -5.49339 -20.8443 -617 2 43.894 32.1911 4.95963 4.52806 -52.0805 -10.2655 -618 3 42.6666 32.0496 5.30411 26.1406 -7.63566 -17.5185 -619 3 44.6473 31.2926 4.419 -30.7677 19.4747 14.2469 -620 4 43.8381 33.9821 5.82617 -35.1808 40.951 30.2942 -621 4 45.3664 33.1691 6.19311 -10.275 -1.0365 4.4818 -622 1 43.9409 35.7078 2.94042 3.22733 -51.5357 -49.9186 -623 2 43.348 36.2006 1.70588 25.8776 -9.12573 -18.8138 -624 2 44.3757 36.8172 0.713167 -7.64912 -13.2689 38.6134 -625 3 44.0628 36.9589 41.4508 -2.41529 3.02373 -15.0868 -626 4 43.9087 36.323 3.69682 4.46748 41.5024 48.5675 -627 4 43.0059 35.3045 1.0879 -7.34341 13.0696 15.3539 -628 2 42.2218 37.2049 1.98307 -32.8685 -0.904888 11.5727 -629 2 41.1062 36.5938 2.90711 22.5622 20.6064 -2.77479 -630 2 39.8757 37.4913 2.92488 9.99264 -5.47282 62.3883 -631 3 39.5847 37.9927 4.02645 -6.88693 1.84466 -13.34 -632 1 39.0832 37.5519 1.86835 -2.09978 -20.426 -31.5908 -633 4 41.7044 37.4782 1.02484 10.2081 4.13789 1.30545 -634 4 42.5649 38.1527 2.49808 3.34998 -7.04672 -12.996 -635 4 41.496 36.4873 3.97615 -8.32458 2.86238 -16.0656 -636 4 40.817 35.592 2.59085 -6.50381 -15.3028 -7.15704 -637 4 39.3467 37.1489 0.943045 -1.18671 2.30285 11.2704 -638 4 38.1024 37.7997 2.00291 -4.61511 13.1634 -1.5169 -639 1 45.5865 37.1913 1.18701 0.34656 3.48246 -50.9957 -640 2 46.5715 37.7193 0.263736 40.0587 13.4866 27.3297 -641 2 47.1476 36.6709 41.2495 -9.99518 -39.8037 -22.9547 -642 3 47.6611 35.6473 41.7682 -3.12622 19.3551 -24.5438 -643 4 45.9505 37.0475 2.10099 0.0710674 -6.02767 36.3056 -644 4 46.0766 38.4733 41.5789 -9.05589 19.6465 -18.4972 -645 2 47.8462 38.4064 1.04164 -24.5048 14.2529 -26.5929 -646 2 47.4036 39.6651 1.82888 -3.7708 6.53308 31.1421 -647 2 48.5926 40.4064 2.51341 13.2626 3.99863 -2.76696 -648 3 49.7104 40.5691 1.98441 -24.6046 -10.5895 -1.86534 -649 1 48.3407 40.8898 3.74779 29.4138 -3.81739 16.8938 -650 4 48.597 38.7482 0.246377 -8.81496 -5.86425 14.2737 -651 4 48.3893 37.7509 1.72975 1.66752 -15.4435 3.74234 -652 4 46.6019 39.4971 2.66308 23.3117 -7.11271 -27.0857 -653 4 46.9261 40.3559 1.12913 -3.21242 13.4997 -7.95635 -654 4 47.3907 40.9351 4.12169 -5.60594 2.69026 7.41827 -655 4 49.1659 41.1473 4.37984 -25.8317 -2.18268 -20.985 -656 1 47.0143 36.8241 39.8589 2.94896 -6.17569 33.9376 -657 2 47.6738 36.0506 38.8108 16.6825 -23.5637 34.6067 -658 2 48.454 37.0258 37.9695 9.24498 -19.2444 17.2828 -659 3 47.9734 37.5867 37.0249 -16.9661 22.5794 -32.933 -660 4 46.3407 37.4883 39.4677 -2.13376 9.43233 0.449621 -661 4 48.4374 35.3321 39.3605 -24.6855 17.1776 -23.0678 -662 2 46.6968 35.2528 37.909 -27.9143 -33.2437 25.7199 -663 2 46.039 33.9895 38.7043 9.93401 10.5983 7.56799 -664 2 46.87 32.6784 38.9289 23.0786 -0.450758 -24.5995 -665 1 47.7656 32.5928 40.0651 -0.0346617 67.7235 50.2506 -666 2 48.5337 31.5574 40.3699 -14.5633 -26.8579 -35.9878 -667 1 48.7282 30.552 39.4879 -2.05986 8.25564 18.106 -668 1 48.8872 31.3858 41.6213 -4.84512 27.348 -3.11289 -669 4 47.2327 34.8627 37.0058 -5.81127 5.13112 -1.60937 -670 4 45.8267 35.9464 37.6192 18.3744 -10.9215 -5.83414 -671 4 45.065 33.6697 38.178 15.3305 12.1509 10.6411 -672 4 45.8045 34.3704 39.7428 -14.1926 -3.74807 -10.9265 -673 4 47.5159 32.4832 38.0006 -21.4463 1.51143 8.96621 -674 4 46.1858 31.8178 39.0967 -9.12823 -0.449275 -15.1225 -675 4 47.7485 33.3794 40.8208 -8.02877 -26.8637 -33.9869 -676 4 48.3609 30.5297 38.5261 -2.43008 2.66571 1.08755 -677 4 49.1746 29.6933 39.8011 5.57148 -11.3344 1.43527 -678 4 48.5595 32.0107 0.447997 -4.49593 6.14729 8.57279 -679 4 49.3675 30.5632 41.8859 20.5825 -37.41 17.1512 -680 1 49.6971 37.2567 38.3612 38.8031 36.8466 -19.9315 -681 2 50.6251 38.1764 37.6375 5.59701 -6.58181 11.8605 -682 2 51.1059 37.476 36.33 -5.39593 -3.52342 3.95062 -683 3 51.4567 36.2851 36.3473 -6.1727 9.88097 2.62067 -684 4 50.1666 36.6257 38.9842 10.5469 -17.0261 18.2142 -685 4 50.0436 39.1015 37.4003 1.48542 -2.85918 -9.88003 -686 2 51.8783 38.6033 38.5414 -14.1699 17.2606 4.5582 -687 2 51.4771 39.4948 39.8067 23.634 -8.13025 9.13717 -688 2 52.8025 39.6936 40.6861 -45.72 0.0787629 30.9804 -689 2 51.0312 40.8873 39.3543 -1.21924 6.71403 17.5275 -690 4 52.6247 39.2003 37.9187 -12.0326 -10.2321 5.24388 -691 4 52.4336 37.7304 38.9418 -1.83231 -8.6555 -7.07863 -692 4 50.6844 38.9864 40.4458 6.67436 6.37453 -9.78056 -693 4 52.9275 38.7652 41.2899 1.57503 4.15297 5.5095 -694 4 52.875 40.6185 41.4124 -9.95772 -27.9304 -22.9777 -695 4 53.6477 39.6981 40.0479 39.2622 9.27083 -23.1198 -696 4 51.882 41.4315 38.8764 -8.78739 -1.58992 -12.4168 -697 4 50.8284 41.5065 40.2813 -10.0843 -5.65437 -12.2377 -698 4 50.1041 40.7893 38.7156 9.84678 12.7352 4.22225 -699 1 51.1335 38.2092 35.1872 23.4477 43.7196 -18.1994 -700 2 51.5372 37.7272 33.8205 5.66277 23.826 53.2621 -701 2 52.816 38.5373 33.39 -13.9696 27.2523 3.91394 -702 3 52.9014 39.7954 33.5824 -9.48934 -35.8428 -1.88315 -703 4 51.0917 39.2914 35.1751 -6.07189 -44.7564 8.7296 -704 4 51.807 36.6734 33.9114 3.67702 -17.8942 -3.77347 -705 2 50.2728 37.942 32.9627 24.5619 2.20768 -27.072 -706 2 49.0946 37.0552 33.3907 -40.4332 32.861 4.12747 -707 2 50.6582 37.6771 31.4819 -4.87136 -12.6088 -15.1928 -708 2 49.1924 35.592 33.2496 18.605 -47.1891 -10.6734 -709 4 50.0222 39.0181 33.0462 -10.0421 3.96713 0.824793 -710 4 48.1822 37.369 32.7965 11.3859 0.507389 5.43773 -711 4 48.766 37.227 34.4352 6.35082 10.8857 5.72377 -712 4 49.7261 37.457 30.8365 21.3715 9.42576 10.5226 -713 4 51.3528 36.7896 31.3856 -11.4398 6.26312 1.5823 -714 4 51.2274 38.5516 31.0485 -10.0605 -6.0953 1.35419 -715 4 50.1827 35.2313 33.6939 -19.2762 -1.86106 -7.31237 -716 4 49.1345 35.3223 32.1629 6.46074 -3.78635 4.92713 -717 4 48.3248 35.0641 33.7333 8.66481 1.90115 0.669024 -718 1 53.7674 37.8522 32.7049 -0.401058 29.0536 2.76503 -719 2 54.8534 38.494 31.9889 21.3589 25.2573 -50.7784 -720 2 0.070256 37.9331 30.5159 -12.6617 -10.513 26.1463 -721 3 0.610536 36.8336 30.3273 -13.153 9.14635 -3.0322 -722 4 53.7049 36.8532 32.6778 5.78014 -33.2974 -6.55066 -723 4 54.4976 39.583 31.7137 12.734 -24.0185 30.659 -724 2 1.32523 38.4582 32.6174 -11.2306 -14.0383 43.8112 -725 2 2.25298 39.4244 31.93 21.239 -3.52493 -6.53852 -726 2 1.82142 40.7594 31.946 9.01925 8.15494 1.3639 -727 2 3.55305 39.1373 31.3858 -52.1121 -37.4601 32.7366 -728 2 2.62719 41.7738 31.436 16.1375 42.966 -9.20235 -729 2 4.2717 40.1621 30.8907 55.019 31.5071 -38.7093 -730 2 3.8753 41.5182 30.8618 10.3374 -30.1635 6.5347 -731 4 1.72137 37.3957 32.6071 -2.968 13.2806 -7.3675 -732 4 1.36361 38.7573 33.7485 -10.0277 -6.08615 -32.1159 -733 4 0.900203 41.04 32.4671 -4.90014 4.47018 0.827909 -734 4 4.05865 38.1292 31.3848 -19.507 10.3261 2.47632 -735 4 2.40669 0.963664 31.507 -12.4107 -17.8541 2.52862 -736 4 5.22734 39.8163 30.4261 -2.17835 18.3508 4.41679 -737 4 4.61313 0.382875 30.4956 -18.9116 -9.53382 4.9162 -738 1 54.5208 38.7001 29.536 -17.794 9.59417 2.44526 -739 2 54.4433 38.3677 28.0932 0.413701 6.77287 11.8816 -740 2 53.8236 36.9714 27.8054 -10.5704 38.9519 24.3324 -741 3 54.2836 36.1684 27.0139 12.3723 -16.7122 -9.38408 -742 4 54.0063 39.582 29.8758 15.9225 -27.1932 -25.0825 -743 4 53.6617 39.0994 27.7122 21.1252 -9.31914 -10.5745 -744 2 0.84771 38.4562 27.3872 5.21129 26.4327 0.415045 -745 4 1.55752 39.2926 27.6564 -22.375 -0.429945 3.27523 -746 4 0.737328 38.5366 26.268 -0.662808 -7.52676 8.67249 -747 4 1.44048 37.5755 27.6711 3.3074 -14.1434 -6.0421 -748 1 52.6712 36.7812 28.4639 -34.4859 10.4254 42.9936 -749 2 51.8461 35.5981 28.5315 7.11639 -32.3641 19.2856 -750 2 52.1287 34.6607 29.761 72.1729 37.4894 -16.6197 -751 3 51.2969 33.8912 30.1393 -37.38 -39.1809 16.7772 -752 4 52.2301 37.5459 29.0797 18.7619 -22.9106 -24.882 -753 4 50.752 35.8045 28.6381 6.6344 10.4547 -3.03351 -754 4 51.9318 34.9661 27.6028 3.27123 7.03186 8.45077 -755 1 53.4041 34.6064 30.3039 -37.1524 -18.2668 23.7743 -756 2 53.8481 33.579 31.3343 19.9058 12.4048 -28.9308 -757 2 53.2753 33.7631 32.7245 -4.20442 17.2631 -10.7202 -758 3 53.3264 34.8931 33.2388 -7.00143 -11.8952 2.65621 -759 4 53.9984 35.4233 30.2821 14.046 11.4873 -9.55867 -760 4 53.5575 32.5679 30.9796 -2.97426 -3.20006 -4.3618 -761 2 0.441949 33.6673 31.397 15.483 24.485 -22.5221 -762 2 1.1159 33.1056 30.111 -2.52249 -22.0361 -11.2405 -763 2 2.65939 33.3504 30.0471 -29.7948 -11.8394 -36.8606 -764 2 3.5253 32.433 30.8659 3.71436 3.74322 35.9681 -765 1 4.92891 32.7835 30.8601 -3.73949 -14.6782 3.94495 -766 4 0.930008 33.1164 32.2052 -10.1795 -8.12889 21.2637 -767 4 0.820281 34.7554 31.5264 -17.1946 -20.5931 1.67355 -768 4 0.726808 33.5631 29.1693 -8.69229 5.5421 6.41341 -769 4 0.816642 32.0044 30.0112 14.0154 14.8269 0.94841 -770 4 2.76655 34.4177 30.2798 16.9839 11.3836 1.64388 -771 4 2.99027 33.2006 28.9712 -4.31169 8.16855 10.4317 -772 4 3.48024 31.3628 30.6286 -9.21502 -9.13385 -9.88849 -773 4 3.14214 32.5157 31.9169 10.307 -3.37241 -3.01155 -774 4 5.38024 32.7641 29.968 4.13535 -6.65161 -12.8027 -775 4 5.44585 32.16 31.4735 7.57437 4.94374 1.68638 -776 4 5.11721 33.7072 31.1652 -0.520286 24.3887 13.7994 -777 1 52.7286 32.6609 33.3217 21.3895 7.82715 -40.48 -778 2 52.3746 32.6765 34.6845 -3.94215 -5.7204 42.1903 -779 2 53.6544 32.9612 35.4718 -32.0777 16.7216 -3.31611 -780 3 54.7101 32.4293 35.2196 26.5529 -12.799 -1.69002 -781 4 52.7346 31.7402 32.8358 -3.66087 10.5856 2.03104 -782 4 51.6553 33.4893 34.886 -4.93781 11.2662 -7.45083 -783 2 51.7389 31.3462 35.1425 36.1525 -8.24878 -2.45066 -784 2 50.4549 31.4357 35.902 -2.56298 9.46411 57.003 -785 2 50.5914 31.9702 37.3969 -4.77582 -10.2539 -35.2763 -786 3 49.9129 32.941 37.7385 4.53321 10.1718 7.36032 -787 1 51.4448 31.3274 38.2318 1.89331 10.2207 20.9211 -788 4 52.4532 30.7011 35.7138 0.934865 4.72627 -2.3237 -789 4 51.5619 30.7887 34.2312 -11.1921 -21.1455 -14.7508 -790 4 50.0197 30.4197 36.0127 -8.03636 -0.273264 -6.56567 -791 4 49.7685 32.1089 35.3545 -11.9583 -2.57651 0.31815 -792 4 51.7323 30.3416 38.1022 2.22495 5.18328 -8.30147 -793 4 51.645 31.7871 39.1631 -4.2657 -12.8631 -21.1898 -794 1 53.54 33.8952 36.4131 -39.2018 -0.531466 -0.79929 -795 2 54.5682 34.2648 37.3102 -29.3437 58.7358 21.9421 -796 2 54.3255 33.5954 38.6431 29.6978 -77.406 0.637438 -797 3 53.3742 33.7807 39.3881 -15.8118 22.9548 5.85491 -798 4 52.6165 34.3686 36.5483 14.9252 -1.63515 2.31459 -799 4 0.525104 33.9954 36.8979 32.3496 -27.0675 -4.05845 -800 2 54.6285 35.827 37.4074 -17.7645 -17.3983 39.0191 -801 2 0.013954 36.4546 36.058 15.6745 -1.04323 18.583 -802 2 0.049019 37.9526 36.293 -63.1087 6.90888 -39.4544 -803 2 1.42802 35.9308 35.6826 4.08802 -6.56861 34.108 -804 4 0.435555 35.9801 38.2063 -13.4425 16.5914 -13.2273 -805 4 53.6198 36.2963 37.798 28.292 -21.2068 -7.80607 -806 4 54.2061 36.2134 35.3084 7.36084 -1.04605 -3.46995 -807 4 54.0713 38.2397 36.8522 27.1057 4.55429 -9.55418 -808 4 54.939 38.4282 35.2643 6.0019 1.58695 18.2366 -809 4 0.927863 38.3313 36.762 28.685 14.2218 21.5028 -810 4 1.30489 34.8989 35.3991 1.43296 -22.664 -21.4406 -811 4 2.25694 35.8344 36.4845 -24.5016 17.8738 -12.6534 -812 4 1.83634 36.4362 34.8335 13.635 15.7788 -26.8996 -813 1 0.008587 32.3758 38.733 13.7846 27.3237 -75.0314 -814 2 54.826 31.3 39.6331 17.4428 -14.6066 45.4768 -815 2 0.455793 31.7866 40.9725 -5.37526 1.66294 14.9859 -816 3 1.60943 32.1773 41.0547 11.2247 3.92934 -7.13086 -817 4 0.661532 32.0877 37.9163 -19.8505 19.9989 33.4434 -818 4 53.7452 31.1425 39.875 0.374502 -5.35979 -15.722 -819 2 0.574437 30.0043 39.0439 11.2157 23.6116 11.9724 -820 2 0.334302 28.7136 39.8578 -22.6665 -11.1233 -21.4622 -821 2 0.695999 28.7 41.3625 12.0844 -36.9796 9.0265 -822 3 54.7253 28.727 0.298109 10.889 15.3071 -4.11946 -823 3 1.91063 28.4506 41.7261 -30.7481 15.8042 -10.4483 -824 4 1.71086 30.1341 39.082 -19.7243 9.32222 0.312381 -825 4 0.358791 29.9926 37.9166 -2.62684 -19.8589 21.79 -826 4 0.882365 27.912 39.2891 -0.232785 0.308618 14.1734 -827 4 54.2301 28.3798 39.7718 17.2545 10.1943 -0.206185 -828 1 54.6325 31.7916 0.156881 38.5875 2.07504 -29.8841 -829 2 54.8631 32.3302 1.45975 7.41407 33.4343 26.7616 -830 2 1.21087 32.0241 2.20189 -33.1211 2.89979 -4.9396 -831 3 1.57835 32.811 3.08735 12.0797 -3.2377 -11.0832 -832 4 53.6756 31.6317 41.8616 -38.5912 -7.03962 0.740029 -833 4 54.9627 33.4927 1.3754 -11.7864 -35.033 -4.32612 -834 2 53.6666 32.0355 2.42828 -17.6969 8.95863 -1.18459 -835 2 52.1933 32.3158 2.0402 15.1012 41.0915 -15.9482 -836 3 51.3911 33.0513 2.74715 36.5037 -34.5123 -13.5772 -837 3 51.9207 32.0348 0.835441 -22.1157 -3.97518 6.29873 -838 4 53.9089 32.5595 3.33158 -2.01457 20.6007 30.7692 -839 4 53.6609 31.0051 2.75768 6.68313 -26.6133 3.27231 -840 1 1.77413 30.8239 1.99288 23.346 -11.0551 12.4557 -841 2 2.99412 30.3649 2.70859 20.7873 20.7026 2.58588 -842 2 4.37767 30.5585 1.9432 -4.58172 12.4342 76.2013 -843 3 5.43315 30.6356 2.6242 -17.4542 -1.84538 -14.1099 -844 4 1.23141 30.1158 1.49013 8.16278 -4.42375 -5.05013 -845 4 3.08709 30.9756 3.71749 -2.54673 -19.312 -31.0286 -846 4 2.99418 29.2776 2.99437 -11.6108 14.2547 -3.21828 -847 1 4.33484 30.73 0.643592 -44.4777 10.1896 -41.2897 -848 2 5.29878 31.2923 41.6537 25.3276 0.744315 3.96016 -849 2 5.54544 32.7486 0.121481 37.2819 -30.872 -27.7426 -850 3 4.68176 33.387 0.67546 -18.5336 28.2868 17.8008 -851 4 3.3891 30.7154 0.224796 5.58966 -1.49205 -0.51948 -852 4 6.30256 30.8588 41.8823 -3.47112 -15.4387 -8.82901 -853 2 4.8423 31.1802 40.1578 47.5835 -21.6785 -9.15502 -854 2 4.71332 29.7742 39.4637 -7.18766 34.2596 -8.85866 -855 2 5.63064 28.6968 40.0034 1.34917 -52.5839 -25.1875 -856 1 5.28494 28.1736 41.3081 -3.70672 3.58414 23.7744 -857 2 6.07557 28.0057 0.492928 -10.4577 4.69864 -29.3733 -858 1 7.37832 28.2278 0.392183 22.9004 -4.79637 26.256 -859 1 5.53705 27.6868 1.66636 -6.4094 -24.443 39.9026 -860 4 5.53303 31.787 39.5095 -0.196101 -2.7377 7.98036 -861 4 3.92152 31.7024 40.0755 -40.4143 20.5365 -6.7059 -862 4 4.89215 29.8961 38.3273 -2.53464 -0.592337 23.8175 -863 4 3.64677 29.4833 39.5295 -2.27017 -8.63927 2.61329 -864 4 6.69627 28.939 39.9328 9.42975 10.3347 -2.35439 -865 4 5.48992 27.7969 39.2806 7.04825 21.6687 20.0754 -866 4 4.27254 28.0467 41.4152 -4.83075 -3.28587 3.65899 -867 4 7.98538 28.2099 41.4852 -8.02405 3.18538 -21.0185 -868 4 7.94047 28.2423 1.24565 0.364194 -0.98827 11.7246 -869 4 4.53186 27.4078 1.78766 14.7644 10.3007 -8.4097 -870 4 6.1013 27.52 2.55737 -8.44391 7.70178 -27.0297 -871 1 6.79596 33.2006 41.6804 -27.9344 8.59735 4.57792 -872 2 7.15148 34.5952 41.8655 -38.9276 -12.1291 -1.68573 -873 2 6.77215 35.2911 40.5652 14.0197 56.9428 51.8707 -874 3 6.49158 34.715 39.5569 -13.5951 -21.5425 -43.0675 -875 4 7.31858 32.7386 40.9072 -2.655 4.76346 14.1821 -876 4 6.52583 35.0505 0.829338 19.3934 -10.3795 -24.0216 -877 2 8.63545 34.7883 0.159249 -4.7809 22.3707 74.7553 -878 3 9.31911 34.1951 41.0459 32.4158 -10.9375 -20.7672 -879 2 9.12239 34.1481 1.54228 -45.3508 12.3646 -39.5443 -880 4 8.86138 35.9031 0.177513 1.59938 -13.4643 1.18346 -881 4 10.1943 34.4871 41.2598 15.0836 -7.29109 -20.5697 -882 4 10.1218 34.4779 1.7295 32.9793 8.82002 13.7556 -883 4 9.1354 33.0404 1.45915 -3.89828 -1.77159 7.54964 -884 4 8.44695 34.5279 2.36236 9.39315 -9.78399 0.0431608 -885 1 6.96309 36.6454 40.6555 -22.2962 -38.3404 -33.8498 -886 2 6.94214 37.5275 39.5132 -15.3576 22.9899 27.1878 -887 2 8.03225 37.1821 38.5547 25.8315 2.87875 -39.3086 -888 3 7.87409 37.2091 37.3037 -11.7489 -2.94068 30.2829 -889 4 7.09017 37.0079 41.5812 4.58243 22.402 24.7274 -890 4 6.01646 37.4072 38.9238 -6.0018 -8.28766 -1.15408 -891 2 7.01182 39.0163 40.0252 -15.3603 -23.3284 55.3652 -892 2 5.61926 39.5384 40.7634 13.0639 11.727 -14.3013 -893 2 5.74741 41.0778 41.0735 34.612 -8.65688 -61.1535 -894 2 4.30485 39.278 39.9775 33.2171 6.29002 -24.4772 -895 4 7.23253 39.6079 39.1676 9.01238 29.648 -28.6912 -896 4 7.91826 39.1206 40.7867 -28.368 0.120823 -25.2036 -897 4 5.4532 38.9933 41.7239 13.5286 -1.18368 4.70417 -898 4 4.88701 41.4539 41.5866 -22.2749 9.39049 21.0562 -899 4 5.89633 41.7578 40.1185 -8.19165 -26.548 25.276 -900 4 6.67066 41.2365 41.6556 -0.494064 4.57358 11.7906 -901 4 4.18164 39.8273 38.9933 8.48456 -7.17755 11.4037 -902 4 3.44244 39.5261 40.5797 -17.807 1.17877 7.97341 -903 4 4.2824 38.1939 39.7929 -10.4691 -3.8299 -8.01616 -904 1 9.23783 36.8543 39.0653 -4.40645 21.0053 19.4908 -905 2 10.3275 36.5838 38.1582 31.0816 -25.3995 62.8998 -906 2 10.2997 35.2224 37.4613 6.04581 38.1949 -0.210763 -907 3 11.0208 35.1071 36.4655 -6.3656 -14.3958 -11.0193 -908 4 9.51333 37.1441 40.0706 -14.9717 -14.5173 -38.8343 -909 4 10.386 37.3498 37.3821 -1.67567 12.3369 -13.0834 -910 2 11.6168 36.6846 39.0604 -5.3878 -32.5356 -23.0633 -911 3 11.6818 35.7254 40.0985 -18.2206 13.507 16.8431 -912 4 11.7318 37.6647 39.5052 6.99822 20.9023 2.76215 -913 4 12.4798 36.426 38.4299 12.1644 16.7594 -11.1747 -914 4 12.2479 35.0511 39.7675 10.0745 -20.8981 -3.76732 -915 1 9.3909 34.3264 37.8733 -42.427 -15.3638 26.6935 -916 2 8.99216 33.1557 37.0842 54.1918 17.4661 1.85655 -917 2 8.44195 33.5842 35.7305 -20.833 60.571 55.2199 -918 3 8.45395 32.8337 34.8033 7.91235 -41.3122 -40.5547 -919 4 8.901 34.4208 38.8182 18.72 -3.57692 -25.7233 -920 4 10.0039 32.69 36.8915 -15.1884 -12.4868 -9.34361 -921 2 8.05349 32.1507 37.7268 -1.844 -26.1592 7.76215 -922 2 8.63612 31.2276 38.7905 8.98886 15.2457 3.52798 -923 3 8.28567 31.4376 39.9878 9.18033 -14.5703 -9.08999 -924 3 9.46172 30.3301 38.4185 -14.4281 10.7169 -2.66077 -925 4 7.57008 31.4717 36.9797 -4.32683 11.3708 2.99534 -926 4 7.24557 32.7088 38.1955 -18.7592 7.98312 4.87833 -927 1 7.76821 34.7903 35.7104 -0.921577 -49.5867 -7.77983 -928 2 7.00589 35.2713 34.5947 28.4194 33.7396 -49.4054 -929 2 7.85162 36.3274 33.7967 14.0615 10.3677 50.876 -930 3 7.59561 36.677 32.642 -11.5138 -12.0529 -0.0837023 -931 4 7.64044 35.3156 36.5601 -2.79577 12.0246 16.4277 -932 4 6.95142 34.464 33.8059 -8.74679 1.13416 10.6726 -933 2 5.60472 35.8897 34.9384 -10.82 -34.5279 -29.2679 -934 2 4.80808 34.6511 35.4252 21.4048 19.1212 -24.4535 -935 2 4.58939 34.449 36.7896 -8.79739 7.49237 6.99756 -936 2 4.44707 33.6361 34.4808 -22.1156 13.6667 13.0483 -937 2 3.78406 33.375 37.155 10.056 16.8174 60.0349 -938 2 3.57928 32.5992 34.8543 35.6828 20.067 14.4288 -939 2 3.32606 32.5122 36.2195 -36.4887 -32.5961 -12.2866 -940 3 2.43989 31.6229 36.7148 -5.7594 -17.052 -20.0699 -941 4 5.14192 36.3424 33.9886 5.39246 -18.3577 14.2305 -942 4 5.60606 36.7583 35.5989 7.01287 1.52307 19.367 -943 4 4.94491 35.1783 37.5598 -4.47364 -7.92921 -7.91861 -944 4 4.66046 33.7427 33.4202 4.87397 4.4658 -8.40916 -945 4 3.45738 33.1597 38.2449 15.2806 17.1295 -26.8514 -946 4 3.26795 31.828 34.148 -6.61111 -3.61155 -4.72788 -947 4 2.1868 31.1622 35.9134 -6.91994 -9.03483 11.406 -948 1 8.90205 36.8981 34.5027 -17.2687 17.5401 -60.9896 -949 2 9.70361 38.0134 33.9387 24.2231 -52.0812 37.3823 -950 2 8.8546 39.1711 33.5701 14.7092 18.0593 -4.53516 -951 3 9.06515 39.7643 32.526 6.45085 3.58457 -7.26619 -952 4 9.11675 36.6435 35.4518 3.62665 -3.0608 21.1339 -953 4 10.3861 38.3235 34.818 -10.2978 3.44266 -21.7419 -954 2 10.5787 37.5562 32.7307 -21.6135 -30.8037 4.74181 -955 2 11.6892 38.5091 32.4223 15.379 -13.1594 38.9153 -956 3 11.683 39.1804 31.4042 4.19267 20.0472 -18.4805 -957 1 12.6852 38.53 33.3751 41.3863 26.0224 -13.8263 -958 4 9.85905 37.4261 31.8504 20.0453 2.40541 7.8736 -959 4 11.053 36.5467 32.9319 -7.17885 8.97611 -4.2567 -960 4 12.817 37.8369 34.166 -15.4043 12.1891 -16.4176 -961 4 13.5001 39.2408 33.2564 -39.0039 -25.8302 4.81098 -962 1 7.96197 39.5631 34.4599 -33.9246 23.5433 37.1278 -963 2 7.21007 40.8276 34.5568 -18.3646 -15.2096 -14.7898 -964 2 8.22007 41.896 34.9201 0.758716 14.3361 -6.26955 -965 3 8.97663 41.7874 35.871 13.0919 -8.40756 13.8683 -966 4 7.83943 39.0508 35.3409 8.95409 -9.59767 0.690263 -967 4 6.70734 41.0591 33.5261 17.9743 -2.28149 22.8597 -968 2 6.0301 40.6247 35.6674 21.3841 11.5647 -11.8815 -969 2 4.89974 39.9794 34.8247 17.8968 2.41192 -27.2216 -970 2 5.64567 41.9074 36.4174 -5.31946 16.9228 -22.0167 -971 2 3.85064 39.271 35.6143 -7.9417 -14.8054 48.1955 -972 4 6.41951 40.0018 36.4929 2.02391 -20.04 -2.41117 -973 4 5.36435 39.2019 34.126 -8.73918 7.93575 11.5905 -974 4 4.48342 40.7424 34.1094 -6.00744 -5.42447 8.5897 -975 4 5.00487 41.8434 37.3074 -11.5574 -14.3762 1.01334 -976 4 5.12929 0.689353 35.6946 7.17582 1.37977 8.89479 -977 4 6.56067 0.460605 36.8355 2.18467 8.54142 -3.2903 -978 4 3.23423 39.9796 36.2601 8.91814 -10.815 -11.4927 -979 4 4.38489 38.5352 36.333 -17.3309 14.265 -14.1697 -980 4 3.16246 38.6765 34.9814 -1.3822 0.0882741 -1.23744 -981 1 8.27901 1.09677 34.1745 -17.8694 -35.8502 15.8719 -982 2 9.1495 2.17731 34.4611 25.5007 24.1899 -15.5427 -983 2 8.44305 3.45517 34.8181 7.33507 13.3767 -14.0082 -984 3 7.22584 3.58853 34.5952 14.73 6.44535 13.4701 -985 4 7.64387 1.07834 33.3925 -5.10967 17.8437 -25.4682 -986 4 9.72616 1.98981 35.3795 6.67437 -11.367 8.50474 -987 2 10.1416 2.3939 33.2727 7.80857 1.28792 -5.65283 -988 2 11.1754 1.27875 33.0535 -29.5709 -1.62172 8.74553 -989 2 12.298 1.25902 34.0434 45.8123 -20.4226 -15.8942 -990 3 13.4264 1.60062 33.6211 -9.09849 2.20405 14.6225 -991 1 12.1286 0.499484 35.1615 13.5856 38.0862 1.93866 -992 4 10.7117 3.33658 33.4062 0.0269402 1.80508 0.780117 -993 4 9.62868 2.54332 32.3022 -11.3844 1.67988 3.84081 -994 4 11.6026 1.39089 32.0291 1.1132 -6.32648 1.88738 -995 4 10.6463 0.304077 33.1517 4.80745 -4.48978 -13.057 -996 4 11.1623 0.324257 35.4356 -7.1112 -9.24345 12.7946 -997 4 12.86 0.645961 35.8984 -11.3978 -13.87 -11.7385 -998 1 9.29061 4.442 35.2624 -22.3208 40.9019 24.8252 -999 2 8.81116 5.82611 35.6978 -18.3987 -9.60009 -41.1421 -1000 2 7.90959 6.36535 34.5148 35.1086 -14.4229 -13.6713 -1001 3 8.27789 6.14754 33.3333 -13.6173 9.04219 21.6414 -1002 4 10.326 4.35425 35.3433 -15.5473 -10.8229 -5.10085 -1003 4 8.07437 5.70026 36.5174 9.02025 -1.47766 10.124 -1004 2 9.99583 6.76313 36.1565 -25.1565 20.6308 -28.9867 -1005 2 11.135 6.93617 35.1361 2.62363 -10.5046 6.46017 -1006 2 12.4502 7.42969 35.8581 -25.4448 -27.2564 -27.4451 -1007 2 12.3858 8.85842 36.3442 -55.084 26.5775 24.6628 -1008 1 13.634 9.41318 36.7712 33.8844 -44.8334 11.878 -1009 4 10.2929 6.30703 37.0832 24.0012 -1.96783 25.2264 -1010 4 9.73373 7.84957 36.4159 -14.1304 -26.7275 0.147522 -1011 4 10.8081 7.68154 34.3572 5.16283 -4.02502 4.78839 -1012 4 11.298 5.9636 34.5725 5.23915 16.0099 8.41141 -1013 4 13.159 7.4137 35.035 25.5516 -2.14082 -10.0364 -1014 4 12.8083 6.68649 36.6117 -1.06896 6.08822 -0.205097 -1015 4 11.642 8.94716 37.2538 22.1051 -1.45756 -27.4817 -1016 4 11.9592 9.50431 35.5025 9.97141 -3.64215 15.7788 -1017 4 13.6538 10.3723 37.0555 -8.09423 13.3796 3.79584 -1018 4 14.2885 9.3339 36.0056 2.60625 13.8446 -5.44478 -1019 4 14.0928 8.83644 37.5176 -15.06 24.3666 -13.6607 -1020 1 6.73429 6.959 34.8261 9.36917 -0.537504 -3.37326 -1021 2 5.68914 7.48312 33.9811 -11.6093 0.198368 -29.7566 -1022 2 4.72257 6.43001 33.3633 23.9678 57.8121 29.6097 -1023 3 3.69345 6.80336 32.8731 -41.5354 18.269 -25.9458 -1024 4 6.5403 7.08067 35.8075 -8.4584 6.57489 23.7637 -1025 4 4.95828 8.08289 34.6274 18.5559 -1.63885 -10.0577 -1026 2 6.30301 8.33887 32.7628 1.61604 -0.894199 46.3222 -1027 2 6.96232 9.68302 33.2113 17.5203 -12.0258 -13.4607 -1028 2 6.11334 10.8061 33.8152 -7.60378 12.6352 19.0416 -1029 3 5.31496 11.4419 33.0422 10.0378 -5.26853 5.86857 -1030 3 6.28181 11.1536 35.05 3.36103 -18.7342 -31.8229 -1031 4 5.5011 8.60814 32.0808 -13.4162 -1.3456 -15.0867 -1032 4 7.01778 7.64283 32.2215 -8.51236 18.4517 -1.11608 -1033 4 7.483 10.1113 32.3225 -5.01151 2.49106 -4.14977 -1034 4 7.84021 9.44334 33.8428 -3.17944 -2.15711 8.7111 -1035 1 4.98957 5.17145 33.408 31.7294 -73.5208 5.3031 -1036 2 4.03057 4.12888 32.9492 20.6717 -14.7005 -20.2168 -1037 2 2.6598 4.36206 33.592 -3.0444 -3.65398 -36.823 -1038 3 2.63368 4.6245 34.7729 -17.9957 9.5377 28.5993 -1039 4 5.93287 4.88555 33.7778 -25.4301 -4.21673 -10.3446 -1040 4 3.97065 4.08898 31.7849 -0.621936 10.7688 28.6704 -1041 2 4.54797 2.73693 33.4323 -9.78314 13.2989 35.3654 -1042 3 5.7396 2.38581 32.8061 3.87836 -1.00687 -28.9834 -1043 4 3.83029 1.94659 33.1597 -9.96533 -6.0451 7.8725 -1044 4 4.7579 2.77573 34.5879 -14.8326 -6.64015 -28.538 -1045 4 6.39905 2.57303 33.4496 16.1931 5.10903 8.49462 -1046 1 1.55493 4.20465 32.7937 9.73391 7.12296 -2.26043 -1047 2 0.143907 4.28394 33.2313 13.768 -18.1657 13.0528 -1048 2 54.6863 2.83094 33.3214 -0.0746788 -18.1404 42.9803 -1049 3 54.7972 2.04898 32.3833 -5.36381 -6.57018 -20.4337 -1050 4 1.75536 3.84626 31.8337 -17.5999 5.97734 12.9737 -1051 4 0.145346 4.72929 34.2869 -5.52407 -1.41906 -16.7638 -1052 2 54.0936 4.99047 32.3072 48.5491 53.4262 27.9832 -1053 3 54.4431 6.39026 32.3568 26.5828 -36.1107 8.98461 -1054 2 52.7233 5.01429 32.8691 -55.1486 3.23885 2.70228 -1055 4 54.1505 4.66496 31.2868 0.0550865 -16.0071 -29.7017 -1056 4 53.7986 6.85268 31.88 -20.6445 25.8891 -20.893 -1057 4 52.6197 5.54793 33.8322 5.93951 -5.3567 9.34144 -1058 4 52.3467 3.98503 32.9647 -9.06602 -5.34833 4.63236 -1059 4 51.9747 5.55452 32.2255 9.49609 -7.51028 -3.22615 -1060 1 54.1802 2.39741 34.5222 -14.8232 32.9081 27.5353 -1061 2 53.4465 1.14651 34.785 33.9277 15.1 -62.0226 -1062 2 52 1.44639 34.4384 -40.9452 -8.29472 -14.3346 -1063 3 51.516 2.52365 34.8247 -1.26544 -9.47139 -8.9244 -1064 4 54.0715 3.07846 35.3501 9.6448 -17.4772 -31.2652 -1065 4 53.9076 0.391021 34.1043 -10.2836 -7.20705 -0.475865 -1066 2 53.6069 0.737389 36.2058 40.6624 3.41232 47.0409 -1067 2 0.15698 0.778637 36.8849 -22.9225 14.5477 7.59965 -1068 2 0.184063 0.045177 38.2545 -1.48959 -18.0819 6.68284 -1069 2 1.19764 0.213126 35.924 -17.0247 17.4527 -16.4279 -1070 4 53.1759 41.6554 36.3315 -4.28574 -19.6707 2.88188 -1071 4 52.9166 1.40322 36.7387 0.80484 4.57892 22.2756 -1072 4 0.570353 1.84035 37.1024 -27.1105 -11.6335 -5.02718 -1073 4 54.3756 0.329349 38.9832 1.77724 8.98271 -8.45905 -1074 4 1.16626 0.241414 38.7954 -11.8595 -7.79047 -8.4361 -1075 4 0.0237 40.841 38.1265 8.8292 11.305 -0.869273 -1076 4 2.1582 0.044818 36.439 11.171 3.86438 -4.7836 -1077 4 1.22244 1.0066 35.1406 25.1303 -1.4606 -0.0516333 -1078 4 0.965216 41.2564 35.3038 -8.75588 -20.9773 6.66787 -1079 1 51.2089 0.49816 33.7614 57.6433 8.13256 28.0245 -1080 2 49.794 0.627079 33.5149 3.58551 37.6409 23.5907 -1081 2 49.1504 41.7362 34.5845 -39.3958 -31.0429 53.6988 -1082 3 49.3072 40.5133 34.7023 12.9245 12.8492 -11.6005 -1083 4 51.5663 41.4343 33.8516 -6.054 3.49016 -14.1934 -1084 4 49.5236 1.72635 33.6347 -1.89472 -11.9516 -1.26615 -1085 2 49.2899 0.093076 32.2111 -20.0469 10.239 -57.1496 -1086 2 49.5504 1.0758 31.0546 44.1484 5.96661 -35.419 -1087 1 48.7105 2.02971 30.4517 -2.34523 -25.3315 39.2373 -1088 2 50.7977 1.22066 30.3277 -75.7848 7.88288 4.96893 -1089 2 49.299 2.59293 29.3763 -23.865 8.39496 11.0232 -1090 1 50.5677 2.14293 29.3127 -12.36 -15.4034 27.3398 -1091 4 48.1533 41.8436 32.187 18.4481 1.21563 9.00361 -1092 4 49.725 40.9798 32.0543 -2.35302 7.24771 -7.56512 -1093 4 47.7373 2.26457 30.8018 19.6426 -7.09987 -8.69392 -1094 4 51.6402 0.582035 30.3922 15.3203 -1.97636 0.19948 -1095 4 48.6832 3.25559 28.7541 24.649 -5.28154 -1.94766 -1096 4 51.2124 2.39582 28.5799 18.4236 6.97779 -14.3308 -1097 1 48.3633 0.438016 35.503 -1.69139 30.1001 11.6909 -1098 2 47.6687 41.7006 36.6492 0.613805 18.6924 -40.9612 -1099 2 46.264 41.3694 36.1307 -7.02361 -30.4834 5.87484 -1100 3 45.3463 0.246853 35.8895 18.8914 5.06283 8.3795 -1101 4 48.1281 1.45816 35.4039 5.5506 -16.4063 -0.101422 -1102 4 48.2062 40.7837 36.9784 6.36967 -2.21031 -8.42979 -1103 2 47.5958 0.687745 37.8565 -25.4558 59.2473 29.5222 -1104 2 46.6931 0.064749 39.0402 -2.78345 4.00632 18.8053 -1105 2 47.0383 40.4557 39.4221 -33.2538 18.6268 -20.4936 -1106 2 46.93 0.927044 40.3419 31.4794 -11.2994 1.29194 -1107 4 47.1354 1.76149 37.5629 9.48386 -42.5729 7.15928 -1108 4 48.6298 0.997945 38.2155 -14.6806 -19.3715 -2.98409 -1109 4 45.5391 0.148422 38.8474 30.3772 -4.98305 -7.99897 -1110 4 47.9695 40.2725 39.9165 32.6255 3.33763 11.188 -1111 4 46.9967 39.7545 38.5575 0.158611 5.44488 0.559019 -1112 4 46.2719 40.0836 40.1333 -2.82757 0.291607 -0.331179 -1113 4 48.0832 1.04093 40.5802 -35.3824 -1.71169 -8.39188 -1114 4 46.4823 0.388091 41.2333 0.118939 13.4124 -7.57083 -1115 4 46.4764 1.95182 40.2253 3.79994 -8.06745 5.67231 -1116 1 46.1155 40.0363 35.9994 32.2071 3.49142 -20.6914 -1117 2 44.9353 39.2817 35.7114 0.014229 -40.6503 61.2515 -1118 2 44.4179 38.8949 37.157 4.06758 -27.6469 18.473 -1119 3 45.1574 38.4668 38.0935 -15.0116 19.769 -34.2637 -1120 4 46.9934 39.487 36.0733 -14.8983 -9.5139 0.794979 -1121 4 44.1193 39.9156 35.4266 -15.9448 22.0113 -37.9939 -1122 2 45.2307 37.9502 34.8403 3.73878 29.7444 42.1248 -1123 2 44.043 37.0324 34.841 -52.9272 -13.7306 14.9234 -1124 2 45.6185 38.368 33.4399 7.42128 1.51593 -38.9882 -1125 4 46.0406 37.394 35.3664 8.69137 1.61483 -3.86581 -1126 4 43.4486 36.945 35.811 20.0159 3.18287 -12.2628 -1127 4 44.3645 35.9957 34.6605 0.118723 -8.68919 -11.9568 -1128 4 43.2413 37.3473 34.1301 7.80666 -3.9283 -7.25571 -1129 4 46.619 38.86 33.4411 -0.357581 -2.40345 0.816384 -1130 4 44.931 39.1517 33.0584 -3.3954 -0.0150932 -1.42103 -1131 4 45.65 37.5606 32.6192 -0.759822 9.78394 24.304 -1132 1 43.0637 38.9039 37.3301 16.2039 -1.11298 52.5829 -1133 2 42.3901 38.4825 38.6382 8.13363 32.9232 -36.228 -1134 2 41.8706 37.0909 38.467 10.8397 -12.8704 71.8875 -1135 3 41.4837 36.7016 37.4073 -23.2793 -18.8499 -56.9312 -1136 4 42.5052 38.9697 36.5072 -31.8536 4.61581 -21.2592 -1137 4 43.1805 38.4127 39.3754 18.2924 -0.774441 22.1039 -1138 2 41.3003 39.5089 39.1545 11.9555 -3.56475 0.849013 -1139 2 41.9844 40.8891 39.6202 11.8289 -38.672 35.4909 -1140 2 41.1032 0.170603 39.4187 0.299182 35.0028 -21.1028 -1141 2 42.4599 40.8175 41.1074 30.4283 -6.43954 -3.58257 -1142 4 40.7378 39.0113 40.0259 3.55617 13.764 -16.8053 -1143 4 40.5882 39.6834 38.2893 4.7664 -2.44084 15.6093 -1144 4 42.9174 41.0251 39.0897 16.4872 7.11459 -27.4623 -1145 4 41.5448 1.21778 39.6878 -5.64292 -30.3916 -9.38981 -1146 4 40.1969 0.063548 40.0003 -21.2204 -0.202137 11.1399 -1147 4 40.8028 0.152067 38.3319 -0.566182 12.1591 9.51378 -1148 4 41.6814 40.5448 41.8308 -8.42244 -8.91154 4.32363 -1149 4 42.887 41.7652 41.4977 -6.37808 7.37928 -6.87517 -1150 4 43.378 40.1338 41.1957 -24.337 0.845851 0.000130478 -1151 1 41.833 36.287 39.5864 -11.7269 -9.12911 -32.1296 -1152 2 41.2021 34.942 39.6247 -13.3362 -7.3841 -33.9439 -1153 2 39.8438 35.1095 40.3167 -2.23182 -18.8086 0.488263 -1154 3 39.8319 35.4679 41.5133 -14.6884 5.15074 -23.9167 -1155 4 42.1857 36.6275 40.4819 6.41783 1.01312 8.70708 -1156 4 41.0734 34.4248 38.4971 0.391294 34.8961 43.783 -1157 2 42.0436 33.9307 40.4129 10.4134 -33.9193 29.8386 -1158 2 41.3224 32.6645 41.0046 18.9395 -8.84266 -15.0635 -1159 2 42.1741 31.41 41.1086 26.4224 -37.0889 -5.20117 -1160 1 43.3231 31.527 0.12404 8.16009 54.2467 4.49909 -1161 2 44.392 30.7336 0.312631 -11.8213 -13.5239 -25.8004 -1162 1 44.683 29.6211 41.5456 -0.875823 -13.5136 -9.93246 -1163 1 45.3567 31.1357 1.10637 -40.5913 52.4111 16.4216 -1164 4 42.6035 34.3028 41.3288 -3.49471 12.9719 -23.3931 -1165 4 42.7742 33.539 39.6653 10.0701 4.50298 5.32726 -1166 4 40.5106 32.3417 40.3808 -25.7726 1.2565 -24.6898 -1167 4 40.8602 32.7415 0.05618 -15.4481 23.3498 31.3369 -1168 4 42.5775 31.2408 40.0556 -4.97325 -9.97334 14.9806 -1169 4 41.5239 30.4863 41.4302 18.1675 25.5375 -11.7586 -1170 4 43.4773 32.5278 0.495625 -12.2609 -36.3484 -6.98406 -1171 4 44.1847 29.2591 40.6938 -0.904676 10.2844 18.7349 -1172 4 45.5197 29.0942 41.8602 -5.70345 -5.08504 -8.10101 -1173 4 45.1981 31.9946 1.67722 9.89922 -9.52065 -4.53153 -1174 4 46.1063 30.5613 1.39407 36.7186 -26.409 10.0907 -1175 1 38.7328 34.6894 39.6013 4.46457 11.7984 -0.102478 -1176 2 37.3765 34.7683 40.1611 -21.3466 -3.56213 -4.53749 -1177 2 37.2086 33.6902 41.246 35.3807 -34.3386 -58.3615 -1178 3 37.7056 32.5617 40.9531 -12.3371 14.3328 36.9617 -1179 4 38.7903 34.2139 38.6548 1.70782 19.6852 25.699 -1180 4 37.2103 35.7436 40.6571 5.74575 10.1154 -0.0963519 -1181 2 36.2415 34.546 39.0669 -3.18027 -0.0437456 15.212 -1182 2 36.1408 35.6492 37.9204 39.4301 -27.8538 10.4422 -1183 2 35.3755 35.0392 36.7616 2.61616 7.91146 -44.6699 -1184 2 35.4893 36.9279 38.4153 -43.6456 26.6605 -35.0263 -1185 4 35.2587 34.5127 39.627 5.22859 0.340849 -7.95454 -1186 4 36.3572 33.4874 38.6664 0.260323 14.7009 0.217726 -1187 4 37.2087 35.8382 37.5664 -16.1128 3.65721 5.42823 -1188 4 35.4477 35.6456 35.7653 9.36321 -17.9472 26.5571 -1189 4 34.3056 35.0154 36.9225 -21.8403 -4.8414 12.2215 -1190 4 35.6878 33.9672 36.6241 -0.675121 9.51327 -11.2908 -1191 4 35.3533 37.7352 37.5449 14.646 -26.9923 30.0517 -1192 4 36.0883 37.365 39.2255 0.238586 8.99863 9.94523 -1193 4 34.398 36.7236 38.7331 27.4296 3.60145 2.66053 -1194 1 36.5178 33.9861 0.43319 -0.886806 18.5628 10.9627 -1195 2 36.4316 33.2481 1.68402 -23.714 -26.6299 -2.13495 -1196 2 35.1244 33.7124 2.42366 15.5385 -30.3313 2.36588 -1197 3 34.7644 34.9026 2.51705 2.20922 -14.5348 -10.7235 -1198 4 35.9714 34.8641 0.38304 3.21168 -9.87759 6.15105 -1199 4 36.3983 32.0948 1.44989 -1.82422 33.6343 5.26777 -1200 2 37.6595 33.5578 2.59019 11.8109 -15.526 -8.95992 -1201 2 37.7925 32.6548 3.8947 -1.46637 37.0951 -40.7395 -1202 2 39.0729 32.9162 4.76145 9.33062 17.9701 -6.69315 -1203 1 39.1272 34.3057 5.34055 -12.0513 -47.2871 -14.6565 -1204 2 40.0361 34.6964 6.22226 19.4309 2.99614 33.8109 -1205 1 41.0505 33.9844 6.76852 5.72064 -28.58 -41.8643 -1206 1 39.7581 35.8909 6.75898 -16.291 -41.0737 -43.8581 -1207 4 37.6558 34.6526 2.69615 5.74115 8.80853 20.4616 -1208 4 38.5677 33.342 1.97837 2.62182 1.38243 0.976295 -1209 4 37.7082 31.6119 3.52088 7.51898 -7.43262 10.1799 -1210 4 36.8684 32.8569 4.46033 -3.22235 -4.22142 15.6354 -1211 4 40.0987 32.7161 4.26669 -27.6432 -2.90908 0.926336 -1212 4 38.962 32.1623 5.56307 10.4764 0.325422 12.3641 -1213 4 38.2956 34.9173 5.26655 4.54825 -8.39051 -8.34855 -1214 4 41.5169 33.1039 6.38476 -28.6266 25.8655 1.14646 -1215 4 41.608 34.3491 7.51377 7.8916 19.9746 23.1278 -1216 4 38.9281 36.336 6.40181 -18.5651 19.0558 1.42199 -1217 4 40.2702 36.4189 7.40653 35.8571 19.9594 40.0309 -1218 1 34.4344 32.6714 2.9841 11.9274 27.4669 5.1488 -1219 2 33.2874 32.9292 3.81699 -8.08564 -7.68863 -5.88537 -1220 2 32.3224 31.7651 3.90854 -17.2979 -17.3182 38.1098 -1221 3 31.6331 31.611 4.98833 24.1293 6.49939 -41.9496 -1222 4 34.8176 31.7057 3.00707 -6.83555 3.8884 -0.368261 -1223 4 33.5991 33.291 4.83995 -4.39941 -8.915 -13.4113 -1224 4 32.6658 33.7351 3.38441 -0.220857 8.92322 -1.65762 -1225 1 32.2676 30.8833 2.86064 7.18924 -6.28537 -11.1453 -1226 2 31.5304 29.6622 2.84554 -44.3988 -8.55194 41.4736 -1227 2 32.0114 28.4719 1.98523 24.1065 42.5964 20.3644 -1228 3 31.2338 27.9142 1.1781 -2.45095 -15.5808 -11.9787 -1229 4 32.835 30.9065 1.99868 7.60542 11.1676 6.22148 -1230 4 31.4977 29.325 3.94534 -1.848 -5.68036 -21.1002 -1231 4 30.428 29.9278 2.63242 23.021 -11.1829 0.219584 -1232 3 33.2484 28.1785 2.03016 -12.1294 -5.65166 -6.61988 -1233 6 29.6841 33.0367 2.60309 -21.6771 -19.3453 -3.47113 -1234 4 28.7948 33.122 2.96731 -0.0142705 6.34055 1.55972 -1235 4 29.6278 32.12 2.27587 17.6678 13.2788 -5.74715 -1236 6 1.91248 24.7582 28.0699 4.20875 0.224039 17.8866 -1237 4 1.01839 24.445 28.2798 3.51323 0.855994 -2.65004 -1238 4 2.43926 24.5752 28.8738 -5.90795 -3.90565 -13.7536 -1239 6 8.97597 35.4266 7.06834 5.04 -9.06312 -1.25332 -1240 4 8.25108 36.0541 6.94232 -0.597114 -1.88223 0.564045 -1241 4 9.78632 35.9205 6.90416 2.6498 8.25727 -2.9232 -1242 6 37.9306 35.2271 23.5275 -29.4197 8.6633 8.88923 -1243 4 37.6331 35.3765 22.6307 -13.538 -1.59668 -6.74716 -1244 4 38.842 35.1051 23.4294 41.2281 -9.97035 -1.96517 -1245 6 11.37 34.6061 20.3231 29.8185 18.8627 -18.7977 -1246 4 10.4583 34.7066 20.5358 -23.2141 -5.0309 12.4901 -1247 4 11.7775 33.9686 20.9051 -0.738527 -14.291 8.66526 -1248 6 3.04799 13.1152 13.5136 35.0099 19.4917 13.0876 -1249 4 2.1896 12.8159 13.7818 -12.1985 -3.35561 6.33527 -1250 4 3.35102 13.7724 14.1976 -9.84998 -14.2313 -17.3692 -1251 6 9.17749 22.3786 24.885 -4.81993 3.49977 17.5169 -1252 4 8.99718 21.9861 24.0258 2.67933 0.293026 -6.97176 -1253 4 8.3097 22.5185 25.3032 2.93356 -2.2731 -6.67367 -1254 6 31.1417 36.1188 7.44168 3.96214 -4.62609 4.57576 -1255 4 30.9859 35.1633 7.26174 3.91063 19.8072 -8.10584 -1256 4 31.8759 36.4086 6.86762 -9.43736 -11.0335 0.220205 -1257 6 20.3122 0.171955 30.1364 24.228 8.43021 7.74329 -1258 4 20.1467 1.09565 29.8896 -9.06662 -5.17995 0.122132 -1259 4 21.2388 0.205679 30.4532 -11.6638 -2.99571 -4.85501 -1260 6 32.6752 3.01477 5.14905 7.73556 0.409651 25.0992 -1261 4 32.0607 2.27652 4.98052 6.16059 10.1356 9.58904 -1262 4 32.7887 3.0902 6.13894 -10.3787 -11.0045 -24.4474 -1263 6 26.2394 8.28697 11.5977 20.1187 4.68976 23.8355 -1264 4 26.2546 7.39802 11.997 -1.81228 7.23555 -2.12718 -1265 4 26.8422 8.82061 12.1901 -18.4274 -19.7459 -23.7973 -1266 6 1.08156 20.2558 0.892389 0.445896 -40.4816 -11.3523 -1267 4 0.921065 19.2784 0.845371 -9.22979 28.4068 22.5673 -1268 4 1.8129 20.2775 0.290341 19.5395 18.0975 -11.5753 -1269 6 29.152 22.9159 1.42964 -10.353 11.3862 1.77115 -1270 4 28.6638 23.7219 1.70393 12.045 -15.0113 -5.27942 -1271 4 29.6471 22.6066 2.20087 0.367353 7.17244 2.17898 -1272 6 34.1439 34.8173 6.47837 -14.6134 34.7664 -13.6599 -1273 4 34.8234 34.3556 6.01831 17.3611 -13.8412 -2.82442 -1274 4 33.8746 34.3136 7.2252 -0.385324 -14.0922 18.4225 -1275 6 25.1602 37.1811 26.5285 37.3138 -10.4299 -24.6025 -1276 4 24.6611 37.8475 26.9305 -29.1138 25.753 30.5337 -1277 4 25.9902 37.6718 26.3423 -2.02618 -10.7722 -5.27175 -1278 6 14.5359 22.233 15.6757 -38.1082 -52.4317 -17.2355 -1279 4 14.0373 21.3219 15.6008 31.4468 51.1923 15.0921 -1280 4 14.2115 22.7284 14.9124 6.42666 2.88962 4.6194 -1281 6 2.85765 5.85542 4.07926 -11.0889 31.9932 11.5474 -1282 4 3.43051 5.71014 4.8302 4.50985 -17.8875 11.7313 -1283 4 2.47546 6.74142 4.27679 -1.8522 -19.462 -7.62003 -1284 6 27.6173 26.7153 22.7048 3.02536 -24.7668 37.2 -1285 4 26.7794 26.2561 22.7471 -5.49099 -10.4557 3.23975 -1286 4 27.5338 27.2427 21.9498 -2.81898 29.5538 -40.3285 -1287 6 17.7815 0.60275 22.3967 -9.44347 22.192 16.8557 -1288 4 17.1106 0.664367 23.1174 8.05472 -4.70436 -13.4643 -1289 4 18.0991 1.53066 22.3547 -2.50437 -12.3009 -7.04453 -1290 6 8.08803 9.43976 10.5674 4.80966 -47.9744 28.0614 -1291 4 8.01535 10.2871 10.1695 -8.25869 32.7817 1.56345 -1292 4 8.12483 9.46261 11.5696 0.628604 12.1613 -30.4224 -1293 6 15.3459 8.71493 30.7579 -11.6347 7.91644 6.32427 -1294 4 15.6589 9.0755 29.9373 15.0271 -3.29406 -15.5675 -1295 4 14.5238 9.21191 30.8811 4.80809 -7.40019 11.405 -1296 6 11.0133 17.2839 37.5617 38.0352 -12.2544 -11.7999 -1297 4 10.7898 18.2056 37.405 -17.5453 -0.0751596 7.29682 -1298 4 10.2607 16.7791 37.8546 -17.0302 3.42722 4.74802 -1299 6 42.1004 25.1498 20.3879 -5.861 18.5914 -24.6259 -1300 4 41.6093 25.7579 19.7998 14.6917 -4.46771 2.10695 -1301 4 41.6207 25.2703 21.1911 -4.19275 -5.86855 25.2901 -1302 6 25.8665 4.70671 33.8486 1.7241 -2.25531 12.4518 -1303 4 25.7694 4.46132 32.9448 -0.891619 -14.6084 -22.569 -1304 4 25.7648 5.65611 33.7952 0.475958 14.7418 11.4125 -1305 6 28.7412 10.81 24.3536 52.8166 -39.1996 0.778281 -1306 4 29.1275 10.6396 25.241 -21.7381 14.0631 -10.6288 -1307 4 29.4032 10.2753 23.8346 -27.1554 16.6107 -4.2243 -1308 6 5.01189 41.8147 11.1021 -10.1881 -24.042 21.7575 -1309 4 5.95007 41.5814 10.9281 -9.39093 5.64723 11.7156 -1310 4 4.65803 41.218 11.8386 16.8172 15.7397 -32.6044 -1311 6 51.752 12.7769 30.1551 43.115 4.76279 10.9474 -1312 4 51.4305 13.1775 29.3474 0.253404 7.28674 -13.194 -1313 4 52.748 12.9494 30.1798 -32.3905 -5.4963 0.108494 -1314 6 7.60816 6.20909 6.53323 -10.2625 -22.9413 3.332 -1315 4 6.75131 6.36879 6.93991 1.04412 16.1391 1.16177 -1316 4 7.47061 5.28848 6.27373 8.51121 0.713964 -9.51027 -1317 6 14.6661 26.987 30.1548 0.873164 4.36141 0.355215 -1318 4 14.582 27.1099 31.1251 1.36022 -4.92112 -14.8153 -1319 4 15.2266 27.7026 29.8055 -8.21389 -0.931444 11.6021 -1320 6 15.3264 3.73283 21.1643 -10.33 -3.58504 -6.01241 -1321 4 14.8638 4.27764 21.8464 -0.83547 -19.2341 -16.6374 -1322 4 14.7237 3.15769 20.6119 12.9204 22.2517 21.9232 -1323 6 18.6273 30.44 6.46759 12.0392 -23.7352 17.6185 -1324 4 19.0475 29.6706 6.98693 -16.3462 35.3997 -15.3304 -1325 4 19.3457 31.0864 6.33287 -5.93154 -6.64461 4.30044 -1326 6 40.7697 1.30953 12.81 -7.42069 2.69181 -0.220133 -1327 4 39.8771 1.67487 12.9664 8.30469 -1.85755 -8.75546 -1328 4 41.0842 1.69163 11.9727 1.23155 -3.30642 0.910493 -1329 6 17.7383 20.7435 41.5913 -9.25323 7.68498 -13.188 -1330 4 16.7989 21.0745 41.5362 27.0903 -5.35562 -1.00027 -1331 4 18.2994 21.1605 40.9095 -9.45455 4.50919 10.4973 -1332 6 20.4558 2.13279 12.3403 -30.0447 18.1891 -47.0851 -1333 4 19.8108 1.39557 12.2573 15.3988 9.29294 19.6505 -1334 4 20.198 2.64755 11.5038 12.9177 -17.2886 33.121 -1335 6 9.85302 37.1833 18.074 6.71136 -14.9304 -23.7857 -1336 4 9.92221 37.5908 18.9423 10.0316 4.42551 4.50256 -1337 4 10.7455 37.1149 17.635 -18.8442 6.56171 18.5414 -1338 6 22.8282 7.40677 18.9114 -6.23678 0.804763 -35.7596 -1339 4 23.277 7.74075 18.0859 -11.7777 -2.90663 21.4919 -1340 4 21.8757 7.287 18.6972 16.9035 1.85128 0.334711 -1341 6 12.8573 6.85868 39.0594 6.78943 -21.4649 -19.4044 -1342 4 12.3495 7.63841 39.2092 -16.9303 20.8315 3.03628 -1343 4 13.4346 6.77393 39.8096 4.28484 1.06254 16.6435 -1344 6 10.1565 2.40612 23.2517 -6.6479 23.561 31.1588 -1345 4 10.4099 1.98923 22.4441 -4.01424 -6.38426 -29.0568 -1346 4 9.49005 3.10319 23.0571 9.63138 -11.2124 -3.87372 -1347 6 12.5542 20.2161 19.5705 -7.34833 3.07917 -34.9419 -1348 4 11.7057 19.8107 19.7825 -3.93433 -3.45282 3.31954 -1349 4 12.4683 20.3478 18.5882 13.2674 0.522362 30.6915 -1350 6 53.8557 6.35775 18.9347 50.5758 7.3162 -16.743 -1351 4 53.0168 6.07594 19.2456 -23.2698 -10.9568 16.0684 -1352 4 54.5479 6.04339 19.5529 -19.4302 5.44353 -5.27334 -1353 6 1.75058 4.00903 13.2441 23.5728 -28.6973 -20.2265 -1354 4 1.21884 4.54583 13.7916 -24.4496 15.7193 15.6535 -1355 4 1.39876 3.10072 13.3493 7.47096 11.1043 -1.96467 -1356 6 2.68902 16.4655 4.58797 17.5454 -16.7281 26.1549 -1357 4 3.46748 16.2798 5.17846 -23.6637 11.3752 -17.7986 -1358 4 3.0109 17.1109 3.97132 2.36318 9.59715 -15.9168 -1359 6 22.6274 7.40182 35.0529 -33.099 -8.93325 -69.8706 -1360 4 21.8922 7.07895 34.3703 46.348 20.1786 48.898 -1361 4 22.5995 6.76718 35.7474 -8.35572 -20.8537 22.0506 -1362 6 30.6396 27.885 19.9 19.0923 35.3411 -25.0547 -1363 4 31.1106 28.5954 19.3754 -18.5592 -24.8751 19.2783 -1364 4 29.9814 27.5098 19.295 5.17179 -8.35919 5.46264 -1365 6 18.3573 9.54392 6.2041 9.96047 7.12844 39.1223 -1366 4 18.327 9.09374 5.37857 3.10343 -12.6247 -24.8999 -1367 4 19.1177 9.18386 6.70986 -9.9052 0.872737 -11.1311 -1368 6 21.018 30.3894 30.8381 -12.2875 -2.46479 40.1773 -1369 4 21.7266 31.0151 30.932 9.98027 8.24448 -8.07198 -1370 4 20.7269 30.28 31.7939 -0.642204 -5.24287 -40.3987 -1371 6 28.323 4.36597 15.0837 1.12527 39.8195 10.6489 -1372 4 27.8986 3.55092 15.2676 -12.4099 -32.2848 2.02696 -1373 4 29.0009 4.19376 14.4446 14.1396 -7.65384 -8.86362 -1374 6 12.7814 0.64254 16.5262 -20.2521 41.8336 -1.49998 -1375 4 13.0387 1.47629 17.0069 -1.64601 -27.4009 -13.133 -1376 4 12.0897 0.933072 15.8712 20.715 -4.46996 16.4219 -1377 6 27.5603 35.1844 8.24072 -26.8161 -1.20469 12.7263 -1378 4 28.0791 35.3455 7.47089 6.94403 2.76433 -19.537 -1379 4 26.8275 34.582 7.96906 18.9853 12.4469 9.56437 -1380 6 24.0704 5.17451 40.9985 43.9791 -14.9803 45.716 -1381 4 24.6298 5.96615 41.2045 -19.6374 -8.83437 -20.0494 -1382 4 23.3625 5.28724 40.4007 -22.1054 20.8081 -27.5224 -1383 6 16.8467 24.9145 28.3061 -32.8066 71.0274 -23.4158 -1384 4 15.8676 25.1613 28.454 39.6061 -31.4713 1.92714 -1385 4 17.0718 25.6559 27.6632 3.37355 -28.1253 20.4487 -1386 6 20.8411 12.7971 17.0095 43.3655 -24.1139 -5.17775 -1387 4 20.9692 13.6698 17.4217 0.0861137 -1.96629 -7.53612 -1388 4 21.7712 12.4167 16.7645 -47.1299 18.5523 16.3808 -1389 6 35.7683 23.0344 30.9263 1.08866 -13.108 5.55839 -1390 4 34.803 23.1301 30.928 3.64223 -3.31893 2.04139 -1391 4 35.9803 22.5404 31.7512 0.26244 15.2618 -11.5602 -1392 6 36.3065 21.404 25.8788 21.1988 16.3215 -11.4752 -1393 4 35.3711 21.2912 25.8279 -29.04 -8.19979 -7.71966 -1394 4 36.6742 20.6179 26.2596 7.44281 -15.7003 9.85929 -1395 6 13.4865 6.74911 5.29345 -32.6693 78.3701 45.7352 -1396 4 13.9616 6.05619 4.98306 41.5093 -80.328 -47.9816 -1397 4 12.7805 7.00791 4.71674 -14.9335 -5.37764 -13.3979 -1398 6 20.8104 20.4092 13.7653 1.99296 11.0688 -14.7475 -1399 4 21.268 20.4545 14.5989 11.9976 -3.76106 7.6647 -1400 4 19.8959 20.3184 13.9984 -15.4264 -4.27358 -1.02469 -1401 6 20.3637 29.125 1.38742 -7.39452 3.20569 15.6829 -1402 4 20.6257 29.8678 1.97015 -13.6171 -7.9879 -3.97808 -1403 4 19.4728 28.7955 1.69287 22.5847 10.4694 -9.78123 -1404 6 50.8792 13.1212 37.2655 -4.22961 23.9091 37.9372 -1405 4 51.3893 12.5589 37.8771 -2.47029 4.54984 -9.0483 -1406 4 50.5869 13.8674 37.8656 5.03029 -21.5284 -25.2034 -1407 6 33.9282 34.1694 20.494 -12.758 16.9363 4.62304 -1408 4 33.9505 34.3661 19.5368 -1.52487 0.481952 13.5649 -1409 4 33.2327 34.7631 20.901 14.0918 -19.53 -17.3949 -1410 6 26.2111 28.0581 27.5584 -15.6012 -12.4051 -9.62147 -1411 4 26.6887 28.3319 28.3498 -5.67664 4.83839 -0.885474 -1412 4 25.2376 28.0657 27.7416 20.5709 -1.16679 -1.23567 -1413 6 7.682 21.3042 4.28531 -31.6563 9.11884 52.3302 -1414 4 8.36407 20.9023 3.81015 41.1991 -18.6864 -33.8238 -1415 4 7.19271 21.9105 3.74865 -6.01459 10.7978 -19.2095 -1416 6 22.0049 15.1615 5.91526 -5.59087 32.8095 7.59658 -1417 4 22.5291 15.4011 5.14076 -1.79158 -8.25489 -6.60562 -1418 4 21.8369 14.2416 6.04435 2.97447 -25.4321 -3.26552 -1419 6 21.7136 24.0096 3.8157 22.5859 -13.9702 -11.1371 -1420 4 22.6792 24.1846 3.95073 -20.2229 4.30251 2.28349 -1421 4 21.6957 23.2604 3.18041 -1.04284 4.75891 13.5064 -1422 6 11.5672 23.7812 12.5534 10.6653 17.5289 -0.525849 -1423 4 11.8567 24.7317 12.4283 -11.704 -31.033 2.93832 -1424 4 11.2483 23.6794 13.4494 -5.02459 5.94744 7.15157 -1425 6 32.3679 18.058 29.8144 -2.59991 12.5874 27.6023 -1426 4 33.2958 17.8537 29.9681 1.40206 -2.08885 -2.88861 -1427 4 32.1708 17.8352 28.9168 3.64727 -16.5589 -23.8097 -1428 6 9.27501 12.3901 30.3257 8.89695 -9.73537 -4.18026 -1429 4 8.97738 13.0169 30.9954 -4.04452 2.00113 -0.0309771 -1430 4 10.1278 12.0418 30.6776 -19.7256 9.24572 -11.0885 -1431 6 40.1671 25.9203 9.1352 -31.1658 -6.55029 4.71016 -1432 4 40.7952 25.2818 9.45931 8.36253 -10.0667 -0.250848 -1433 4 40.6474 26.7215 9.01492 17.3912 21.2934 -6.4579 -1434 6 43.1616 32.3487 37.3267 7.45809 -19.2286 11.3512 -1435 4 42.8399 32.8446 36.5586 -11.2032 -5.45956 10.184 -1436 4 42.4733 31.7245 37.6799 8.3011 17.0164 -20.2151 -1437 6 44.0911 6.28198 31.259 8.64406 -6.47735 -33.2401 -1438 4 43.4563 6.84482 31.6606 -21.1773 24.4303 10.8162 -1439 4 44.5952 5.92873 31.9644 15.9286 -14.2375 24.3689 -1440 6 10.2063 18.8787 19.6978 14.6089 -0.63771 -2.74842 -1441 4 10.128 18.3979 20.5267 6.04825 -4.13467 -1.20166 -1442 4 9.36891 19.3219 19.635 -15.0357 8.38504 -1.1225 -1443 6 7.0561 15.5922 15.0299 -16.4573 19.9198 -23.3889 -1444 4 7.18612 15.4783 14.0721 1.05096 2.95086 4.94392 -1445 4 7.41457 14.833 15.4354 13.8635 -34.6267 13.25 -1446 6 24.544 3.4899 27.8655 -14.5565 -8.97091 -7.81951 -1447 4 23.6823 3.28725 28.2588 1.61952 11.0081 14.175 -1448 4 24.3729 3.16547 26.9791 10.0044 -2.74415 -7.35546 -1449 6 54.4109 31.8087 9.71194 -6.99911 23.6955 33.3298 -1450 4 53.8413 31.5567 9.00593 -8.22136 -4.9258 -26.1741 -1451 4 54.0752 32.6964 9.97695 10.2913 -15.383 -7.59421 -1452 6 6.81072 17.0817 36.2069 -39.6649 -0.569341 -18.8672 -1453 4 5.9036 16.7161 36.0961 17.2423 3.35707 18.397 -1454 4 7.03883 17.1994 35.2786 19.8939 2.17194 6.76773 -1455 6 28.6373 7.46216 20.4204 -3.00228 3.72915 -26.9716 -1456 4 27.791 7.71165 20.8314 -1.23568 -3.59083 -7.19581 -1457 4 28.5788 7.67124 19.4449 -3.89686 1.20908 30.1283 -1458 6 17.0427 1.7136 8.36469 -7.39711 4.96373 -17.441 -1459 4 16.9511 0.79552 8.17539 8.34993 -30.6792 14.2707 -1460 4 16.7364 2.03503 7.50962 2.58977 23.9868 7.32556 -1461 6 19.1319 19.334 35.5748 25.2315 11.3156 3.71898 -1462 4 18.4163 18.7293 35.4559 -12.7574 -15.0058 -3.77114 -1463 4 19.9108 18.8059 35.8312 -7.49406 2.79856 2.97864 -1464 6 7.31044 31.3665 13.5876 -12.5896 -10.3186 -18.1643 -1465 4 6.86348 30.5057 13.838 5.41483 30.5465 -8.86898 -1466 4 6.71656 31.9291 13.023 7.05746 -22.9991 7.02109 -1467 6 16.6555 5.24573 12.8486 0.44122 -36.1931 20.2204 -1468 4 17.4189 5.79101 12.9112 23.6003 17.0932 2.01526 -1469 4 16.8511 4.45507 13.4194 -12.0332 11.5633 -21.5138 -1470 6 43.8917 12.7482 34.58 -33.2024 -13.6106 -1.45858 -1471 4 43.9807 13.5999 34.156 2.60816 15.5254 -0.13451 -1472 4 42.9242 12.5381 34.5161 22.3754 -3.96122 -2.5942 -1473 6 42.656 36.4522 28.5282 -7.17959 22.9727 1.13167 -1474 4 42.279 37.3416 28.6522 -7.55712 -15.8866 -0.526154 -1475 4 43.5285 36.675 28.2003 16.3904 -10.8581 0.329061 -1476 6 35.3704 15.0467 6.02622 35.7531 43.3754 17.6476 -1477 4 35.9258 15.8884 5.86958 -26.5611 -35.5954 0.991204 -1478 4 34.7923 14.9488 5.27074 -5.69332 -0.0870189 -10.0798 -1479 6 19.4034 5.85396 6.19026 -42.6676 -37.2433 -25.4755 -1480 4 18.4973 6.11578 6.46985 14.7962 -6.51198 7.73248 -1481 4 20.0178 6.47164 6.48735 29.6225 43.4574 23.1864 -1482 6 29.2636 38.16 6.98139 -51.0091 34.2659 0.167673 -1483 4 28.4794 38.0546 7.56687 16.6219 5.90534 -14.0005 -1484 4 29.8812 37.5458 7.29338 34.0617 -33.3732 10.6718 -1485 6 19.3639 26.1879 8.4772 -1.75021 -19.5484 18.4946 -1486 4 19.3765 25.7536 9.37133 0.505418 11.6152 -20.7618 -1487 4 20.132 25.8039 8.02679 -2.64689 1.58972 6.88257 -1488 6 4.91801 16.6546 6.12902 16.8332 -1.31437 8.04366 -1489 4 5.58152 17.3 5.84506 -6.45866 4.1219 -0.991793 -1490 4 5.39084 15.8022 6.09449 -7.75564 17.9483 -2.53018 -1491 6 6.07873 16.6931 28.0679 20.4204 4.35008 -35.2212 -1492 4 5.19925 16.4426 27.8453 -29.7482 -9.15572 9.47762 -1493 4 6.44387 16.7631 27.1426 -3.77999 2.92972 38.3228 -1494 6 21.7313 29.3584 22.0941 -19.989 26.599 40.0594 -1495 4 21.5191 30.3374 22.0902 3.30888 -28.6715 -0.0155919 -1496 4 21.2646 29.0087 22.9228 20.4195 8.84702 -28.341 -1497 6 24.487 0.545827 12.8459 24.5625 -19.0276 8.44191 -1498 4 24.0381 0.883409 12.0817 -9.22903 10.6064 -10.7293 -1499 4 24.0836 0.980384 13.5911 -6.14963 8.46579 8.44801 -1500 6 18.4109 28.2545 40.3162 -15.9129 36.5713 -32.2972 -1501 4 18.3366 27.7076 41.0573 0.952339 -31.6797 34.0712 -1502 4 19.1875 27.9677 39.8503 10.0284 -2.61836 -5.50219 -1503 6 10.3807 17.4604 21.8947 -1.20821 -16.3296 3.13877 -1504 4 9.80057 16.6779 21.8113 10.8468 3.86983 1.60142 -1505 4 10.0443 17.9356 22.6521 -9.33664 9.03137 6.2204 -1506 6 13.5404 13.3591 39.6327 12.5768 11.767 30.0264 -1507 4 13.9188 14.1992 39.2886 -9.97897 -11.5724 13.3172 -1508 4 13.5464 13.3749 40.6413 1.33606 5.90172 -38.0522 -1509 6 19.5508 26.0247 24.7387 -47.8665 -1.21537 -13.2845 -1510 4 19.6189 25.3328 24.097 -5.62542 -9.91951 -19.3965 -1511 4 20.3649 25.9852 25.1641 45.3739 3.88293 31.7071 -1512 6 8.93445 25.8823 20.0822 -10.4543 -29.9419 8.18251 -1513 4 8.35083 26.4773 20.5043 -33.2288 11.519 27.1484 -1514 4 9.504 26.5029 19.6962 43.6798 16.1155 -28.0388 -1515 6 13.4493 41.2138 30.5102 -4.84662 -36.1256 25.75 -1516 4 14.2597 41.094 31.0483 -5.58856 8.18726 -8.9115 -1517 4 12.8416 40.5025 30.8796 12.8197 27.661 -18.9522 -1518 6 21.1596 21.6794 11.1163 10.7366 20.8259 2.41134 -1519 4 20.9554 20.8709 10.6777 -10.2383 -24.5438 -10.817 -1520 4 21.2276 21.4421 12.046 -2.84377 -3.57945 5.82209 -1521 6 43.5643 10.3136 15.5616 17.5969 -21.741 5.94749 -1522 4 43.2379 9.48961 15.149 2.99942 14.1859 3.68588 -1523 4 42.9802 11.0242 15.3396 -21.8087 10.2132 -10.2755 -1524 6 23.5302 5.07333 12.3088 -23.5628 55.8128 -25.3063 -1525 4 23.4112 4.1923 12.0373 1.19089 -49.3933 -5.08619 -1526 4 23.0178 5.53904 11.5656 24.5614 -12.3881 30.382 -1527 6 9.28539 15.401 4.24759 1.63269 -5.62651 -9.8947 -1528 4 9.02922 16.1115 4.82738 -12.4128 14.4693 4.40189 -1529 4 9.90895 14.9318 4.78697 15.8319 -9.58935 3.85081 -1530 6 26.711 10.8797 17.566 5.43365 -10.3343 -26.0937 -1531 4 26.4818 11.0142 18.4585 -6.06422 3.32013 41.5711 -1532 4 26.8019 11.7518 17.1937 0.341074 3.88847 -5.26754 -1533 6 26.0592 23.5875 33.6794 25.1455 50.9154 21.2543 -1534 4 25.4682 24.0785 33.1024 -8.24785 -6.01089 -9.80751 -1535 4 26.6604 24.3213 34.0779 -26.6739 -38.162 -12.8336 -1536 6 7.57385 10.4949 28.9097 -14.7972 2.07126 0.456687 -1537 4 6.75277 10.5859 29.4011 -5.17598 -12.8295 -3.89358 -1538 4 8.06091 11.2035 29.3139 24.0536 5.38729 3.77373 -1539 6 16.4953 16.9073 24.6459 13.4535 22.6993 31.6086 -1540 4 15.9363 17.7011 24.6942 7.46422 -1.49957 -9.096 -1541 4 16.1467 16.4045 23.9375 -12.5815 -17.1437 -28.632 -1542 6 12.5505 12.7927 0.441559 26.7797 -18.4986 61.4448 -1543 4 12.8902 12.7839 1.42408 -16.6807 15.1369 -51.7767 -1544 4 12.972 11.9767 0.117581 -17.3776 3.59908 -10.4186 -1545 6 6.80454 2.46926 9.04378 10.3033 -16.1572 19.5551 -1546 4 7.05376 2.92505 9.85651 -1.04006 9.78535 -3.84035 -1547 4 7.36555 1.67892 9.06596 -6.07141 -1.3767 -9.09165 -1548 6 28.8788 11.8454 12.005 47.3119 33.3239 7.75537 -1549 4 28.2175 12.4307 11.6211 -4.89696 7.77957 0.00959457 -1550 4 29.7805 12.2922 11.8721 -37.0304 -14.6121 1.30522 -1551 6 44.6756 32.5924 29.7091 -46.8228 -4.47104 18.0754 -1552 4 43.7214 32.9254 29.5641 42.8383 -8.78111 -1.84094 -1553 4 44.558 31.8742 30.3802 4.31467 20.1075 -17.1439 -1554 6 28.6099 15.1189 32.288 -8.09168 -64.7739 -6.10589 -1555 4 29.0591 15.887 31.9855 13.2175 18.1439 -15.8441 -1556 4 29.0109 14.3064 31.825 -10.272 37.9041 18.9788 -1557 6 1.13952 22.1955 33.6303 -59.4889 25.247 28.7943 -1558 4 0.675447 22.8098 33.0333 5.4615 -9.68619 7.91413 -1559 4 1.8611 21.9185 33.1521 52.5767 -22.4691 -40.0321 -1560 6 17.4529 16.8222 9.92046 -20.0761 -24.0842 48.1247 -1561 4 17.9341 17.1517 9.19999 21.5054 13.464 -32.8219 -1562 4 17.9802 16.1035 10.3295 -2.40424 8.44812 -14.2536 -1563 6 18.74 29.8021 14.3918 16.1488 4.65404 69.9188 -1564 4 19.5966 29.6355 14.8679 -24.5899 1.22938 -11.6521 -1565 4 18.9027 29.6655 13.4911 13.4763 -5.12933 -46.2854 -1566 6 39.4106 6.51176 13.0171 8.18439 9.54271 -9.98348 -1567 4 39.7968 7.3217 12.6105 -7.82756 -18.4389 5.68309 -1568 4 39.8965 5.76959 12.6221 -1.11983 7.69721 6.02388 -1569 6 54.1122 38.2735 14.316 -26.3921 15.7841 23.5556 -1570 4 53.5092 38.7211 14.9446 14.1224 -15.8084 0.476194 -1571 4 53.7657 38.6747 13.5269 5.67525 0.359642 -25.5906 -1572 6 7.51656 32.0218 20.9281 34.7748 10.0158 34.1931 -1573 4 7.08362 31.9253 20.1193 -22.6959 2.07513 -43.8223 -1574 4 7.03544 31.4175 21.4603 -12.2713 -14.4046 24.4342 -1575 6 26.9722 15.5137 13.836 8.2831 -9.07996 -12.1546 -1576 4 27.2905 14.6773 14.2204 -10.3825 7.39938 7.42218 -1577 4 26.0228 15.629 13.9568 -6.27371 -3.74993 11.5294 -1578 6 18.3731 16.4369 32.1258 -5.47484 6.15837 -16.1574 -1579 4 18.1737 16.7054 31.2071 -0.945967 -8.38127 9.44724 -1580 4 19.0036 17.0959 32.4159 12.6478 4.85619 3.13766 -1581 6 52.4904 31.6749 23.2282 -45.8236 3.94874 65.5164 -1582 4 52.5054 32.2301 24.055 -6.11863 -14.7847 -21.5508 -1583 4 53.2278 31.9578 22.7624 44.676 11.2926 -39.5338 -1584 6 2.17063 9.69676 28.2025 -10.599 22.0242 17.0864 -1585 4 2.41083 10.574 27.888 12.6445 -0.15763 -12.1006 -1586 4 1.36653 9.91172 28.7063 1.66945 -10.1846 4.32482 -1587 6 32.9295 0.084333 22.579 -26.8721 -17.4052 -13.8633 -1588 4 33.2309 41.109 22.2818 0.690852 17.8844 8.89147 -1589 4 33.6446 0.598803 22.932 23.7791 -0.031599 0.0852179 -1590 6 20.7171 41.5453 38.643 51.9522 19.855 -62.1487 -1591 4 20.0643 41.0408 39.0691 -29.2365 -22.9372 13.5286 -1592 4 20.9788 41.0468 37.7869 -12.0924 18.2625 49.3819 -1593 6 43.2965 24.3242 12.1559 29.4143 27.7167 -28.3716 -1594 4 43.2964 25.2918 12.2975 -10.3211 -14.9579 7.88207 -1595 4 44.0244 24.2792 11.4826 -12.2932 -11.2644 22.4039 -1596 6 22.0333 36.2992 11.8143 -17.8744 11.1706 -5.23693 -1597 4 21.6038 36.9407 11.2131 12.0614 -9.84488 11.7859 -1598 4 22.8639 36.0559 11.3996 4.49067 -2.6397 -1.6843 -1599 6 50.7446 20.5307 30.3299 -19.4296 24.1009 0.394401 -1600 4 50.3769 20.0585 31.0978 -4.60399 -0.499453 -6.82258 -1601 4 50.1204 21.2977 30.1594 19.9431 -26.9935 4.34337 -1602 6 20.8379 3.84934 18.1872 -10.63 2.24574 17.9634 -1603 4 21.6372 4.15439 17.7675 6.81748 4.13844 -2.44268 -1604 4 20.7537 4.31685 19.0447 1.53322 -4.30004 -12.0579 -1605 6 4.001 20.6421 6.99361 -18.7611 -9.71733 3.72301 -1606 4 3.09723 20.6004 6.53941 30.5715 -8.65918 22.3858 -1607 4 4.00786 20.2035 7.89591 -15.2068 14.2544 -28.772 -1608 6 11.948 15.4413 41.4409 9.86263 -45.3449 -5.39948 -1609 4 11.9713 14.4541 41.6361 -2.32711 35.624 3.02695 -1610 4 12.4708 15.4889 40.6181 -5.28805 11.0492 6.42 -1611 6 3.00764 18.5435 38.9252 6.90717 -29.584 40.0663 -1612 4 3.56523 17.7255 38.8717 -9.75827 16.9893 -1.25399 -1613 4 2.92934 18.9138 38.0721 -1.66709 15.3109 -35.9518 -1614 6 8.5978 38.8858 11.3072 48.4025 32.5603 4.46589 -1615 4 9.44036 39.0024 10.7943 -20.5341 -1.07382 9.55064 -1616 4 8.19448 38.1327 10.9484 -22.3544 -46.6733 -17.9601 -1617 6 12.9691 33.9778 38.4933 34.8069 -13.3685 -21.4899 -1618 4 12.6573 33.2385 37.9471 -9.06758 1.22663 10.2849 -1619 4 13.9307 33.983 38.2659 -20.4066 10.3952 14.8996 -1620 6 4.69069 11.9902 6.04709 5.57568 0.955193 2.63183 -1621 4 3.83092 11.6207 5.79405 1.19943 -2.71585 -3.65246 -1622 4 5.36696 11.7708 5.36999 -19.9658 -4.94035 2.87891 -1623 6 10.8381 15.9154 25.2196 -36.4648 2.02786 -4.38258 -1624 4 11.7191 16.2167 25.3262 31.8449 11.9168 5.4517 -1625 4 10.3518 16.6682 24.8476 5.65772 -8.76316 -0.529027 -1626 6 20.7604 3.23767 6.55488 4.15603 28.9608 0.670607 -1627 4 20.2106 2.56517 6.18958 -7.79877 -24.0058 -5.45951 -1628 4 20.2434 4.04703 6.45055 -2.36445 1.41903 2.77062 -1629 6 47.6381 39.1588 31.2153 -11.506 28.7103 -40.9212 -1630 4 46.7125 39.0803 30.8864 16.1685 3.01672 12.9065 -1631 4 48.0161 39.883 30.6238 -10.851 -36.2784 24.6994 -1632 6 8.33868 27.7571 27.6932 -33.938 3.65348 13.4266 -1633 4 7.90796 26.9962 28.1436 6.90464 18.5991 -0.450451 -1634 4 9.05762 27.3551 27.2376 19.8804 -10.068 -12.1598 -1635 6 33.245 40.3099 33.4253 18.3517 22.2199 -28.9554 -1636 4 32.5937 41.0038 33.2194 0.94932 -12.4457 9.89811 -1637 4 33.9479 40.492 32.7526 -7.59275 -9.33057 17.0692 -1638 6 24.5058 34.6327 27.2588 -1.70215 14.4876 -27.3243 -1639 4 24.8356 35.5409 27.0166 -5.53884 -24.0927 13.0812 -1640 4 24.1351 34.315 26.3934 7.47117 3.95694 29.9195 -1641 6 13.3256 36.76 35.7403 23.371 22.3884 -21.319 -1642 4 14.292 36.6204 35.8687 -19.0607 -2.42845 14.454 -1643 4 12.8134 36.0651 36.1242 -8.79549 -23.1532 9.33092 -1644 6 34.0568 20.1616 33.2139 18.2744 1.49148 -3.34215 -1645 4 34.901 20.3965 32.7524 -27.9907 10.0382 9.43414 -1646 4 33.5726 20.9405 33.5892 13.555 -8.0917 -8.63642 -1647 6 22.8329 33.5616 31.6214 -12.6844 15.5573 -21.5595 -1648 4 23.5755 34.1858 31.5969 1.53708 -3.14405 -0.637663 -1649 4 23.0292 32.8658 32.2325 13.4469 -12.4025 17.113 -1650 6 23.7434 2.42786 19.8498 9.49596 22.5629 12.9133 -1651 4 24.532 1.90722 19.7117 15.1933 -8.07802 -2.32773 -1652 4 23.0629 1.99408 19.3682 -23.4605 -15.8437 -14.4607 -1653 6 10.59 1.63974 20.5169 -0.95575 -6.83071 6.14558 -1654 4 9.98705 1.03236 20.0473 7.71399 2.84727 3.14747 -1655 4 10.6246 2.47233 20.0276 -8.35822 1.7372 -3.87231 -1656 6 6.50082 24.8628 7.81243 5.63459 3.09475 -4.38693 -1657 4 7.40706 24.9537 7.44087 -14.825 -10.0154 1.3351 -1658 4 6.01351 24.1359 7.38457 10.3118 5.93376 -6.27471 -1659 6 54.7907 32.5298 25.4601 2.42441 14.1538 -12.299 -1660 4 54.0693 33.194 25.3949 12.697 -15.3913 -0.923548 -1661 4 0.387469 32.6052 24.6546 -22.4501 -0.197402 25.3904 -1662 6 6.24565 20.1804 28.9699 -20.0835 16.2671 13.5362 -1663 4 5.37616 20.2206 28.5173 17.3942 -4.89439 1.50138 -1664 4 6.85708 19.7029 28.4106 5.94408 -11.9876 -6.03836 -1665 6 50.061 21.6087 11.3404 -11.515 44.0552 -42.0488 -1666 4 50.9725 21.751 11.0493 2.56545 -3.3262 -1.97817 -1667 4 50.0662 20.9568 11.9903 8.13397 -42.2403 36.0281 -1668 6 43.4741 33.5215 19.648 39.1267 -7.16957 -40.9914 -1669 4 43.8052 33.5504 20.5247 -1.27694 2.64583 28.8889 -1670 4 42.5461 33.5822 19.6063 -36.855 5.29583 12.3512 -1671 6 30.8225 7.19458 41.0729 -33.0718 18.8928 10.1641 -1672 4 30.0173 7.64992 40.6345 32.3343 -18.9847 22.962 -1673 4 30.7853 7.47469 0.131591 -1.52838 -8.42988 -38.7943 -1674 6 12.1264 25.8478 11.0965 -41.5825 -1.76886 -24.0951 -1675 4 11.2804 25.9828 10.5746 22.2453 -8.09118 27.7312 -1676 4 12.6111 26.6214 10.8799 25.9351 22.819 -1.42381 -1677 6 47.8207 5.82713 17.7363 28.7614 -16.7343 -8.46055 -1678 4 48.0335 5.15295 17.0353 -2.74159 24.5551 13.4979 -1679 4 48.6986 6.12754 18.0988 -19.3132 -4.26463 -8.98138 -1680 6 35.1697 12.9074 16.5814 -26.6969 23.1645 14.7724 -1681 4 35.331 12.9801 17.5341 9.94288 -5.95548 -5.31324 -1682 4 34.5116 13.6489 16.4838 18.7069 -22.8028 -11.189 -1683 6 10.4746 10.6344 33.9856 -30.1195 -20.4446 -6.31426 -1684 4 10.7944 11.3866 34.5009 -4.55531 -6.56386 0.452866 -1685 4 9.59186 10.377 34.349 25.6427 10.4215 -3.60637 -1686 6 9.86976 7.46809 9.66723 13.2706 -15.2427 -11.6817 -1687 4 9.07254 8.00079 9.6953 0.322066 10.4083 -1.78771 -1688 4 10.1027 7.29929 8.72005 -15.6005 8.2826 19.6359 -1689 6 11.1498 9.5629 29.1446 -4.60031 -6.3451 3.75047 -1690 4 10.6862 9.26798 29.9509 5.10767 2.07156 -10.4371 -1691 4 11.3249 8.76682 28.6116 2.75639 0.845127 6.4689 -1692 6 46.3982 12.7571 37.8973 13.0728 8.65129 -14.0384 -1693 4 46.6651 13.0033 36.9771 -6.5436 -6.98702 17.4091 -1694 4 46.8422 13.384 38.4935 -4.33131 -5.25976 0.421567 -1695 6 4.7745 19.0249 15.9997 -22.3762 2.96494 22.3523 -1696 4 4.16029 19.0173 16.7572 4.82074 7.85299 -8.34635 -1697 4 5.51792 18.5695 16.4006 17.242 -3.98645 -13.636 -1698 6 50.2756 39.8187 19.3535 -48.7732 -19.7782 -8.19609 -1699 4 50.1357 39.0812 19.9713 14.3147 6.83039 4.1366 -1700 4 49.4547 39.7468 18.7938 35.5854 8.27631 5.22634 -1701 6 3.57022 23.2982 26.3116 -7.21736 12.7853 -4.33091 -1702 4 3.04677 23.327 25.4841 2.15403 -9.28995 15.8001 -1703 4 3.1589 23.9918 26.8774 3.27351 -16.4313 -7.87876 -1704 6 43.3323 18.2357 20.5099 -9.76971 -1.121 -6.56922 -1705 4 42.7632 18.9863 20.7177 2.34101 2.93749 0.115163 -1706 4 43.9096 18.122 21.2711 1.48233 -4.92166 7.17918 -1707 6 14.4939 41.5272 19.7194 7.33174 -3.95938 -8.98841 -1708 4 13.9791 41.768 20.4704 -25.804 7.49044 14.4407 -1709 4 15.35 41.4773 20.1189 24.9681 -5.23262 -6.74673 -1710 6 29.2751 29.8624 26.915 55.5011 14.3278 -64.7852 -1711 4 29.462 29.6739 25.9095 -28.0317 9.76644 54.5148 -1712 4 30.1137 30.3565 27.1616 -29.5885 -20.0698 8.89328 -1713 6 6.32585 26.1455 11.5441 3.18215 15.5722 27.8672 -1714 4 6.22913 25.7559 12.4173 -5.87839 -9.43723 6.04013 -1715 4 6.88652 26.9071 11.7431 3.72153 0.148286 -16.8953 -1716 6 27.6581 9.23325 15.2376 24.6795 20.4415 1.81178 -1717 4 28.3906 9.86787 14.9946 -20.7277 -22.2866 6.02651 -1718 4 27.7257 8.49599 14.6233 3.42822 -3.8556 -2.27597 -1719 6 29.7826 38.0629 17.0951 -21.7625 -1.10982 -31.3954 -1720 4 29.5447 37.2807 16.5438 11.5646 7.7876 16.1146 -1721 4 29.1666 38.7512 16.7768 9.10566 -6.75007 12.2127 -1722 6 52.2237 28.7307 4.26632 40.7154 12.5569 -19.536 -1723 4 53.094 28.6942 3.75761 -25.982 6.02481 23.1744 -1724 4 51.8384 27.8718 4.17524 -3.40498 -27.0863 -4.04919 -1725 6 17.1651 16.6761 6.10093 10.0081 29.999 -15.4838 -1726 4 17.0645 17.5224 6.60658 -3.46995 -23.4179 -4.25622 -1727 4 16.9429 15.9406 6.65512 -3.52922 -13.7209 19.1007 -1728 6 36.6584 7.55275 33.426 1.51046 -27.4434 34.6673 -1729 4 36.0562 7.00422 33.9909 9.38132 12.247 -13.9906 -1730 4 36.0891 7.78594 32.7139 -15.8398 12.8789 -25.2624 -1731 6 26.1693 3.13272 9.58463 26.4836 36.1065 -53.3475 -1732 4 26.5189 3.61335 10.3026 12.8321 10.8542 33.1136 -1733 4 25.6805 2.43597 9.90138 -37.6231 -51.1462 30.1839 -1734 6 1.19232 17.1076 33.1734 0.722887 26.1228 -9.87087 -1735 4 1.0219 17.7977 32.4875 3.44775 -13.3597 11.6369 -1736 4 0.89275 17.4757 34.0242 -0.842403 -4.58413 -3.86686 -1737 6 29.175 10.1805 5.37687 2.48705 -7.47299 -1.58449 -1738 4 28.5307 10.3443 6.0806 2.54341 -1.49901 -0.102048 -1739 4 29.6529 9.35261 5.56356 -13.9845 3.47491 -0.693848 -1740 6 9.21964 21.135 0.193729 30.6013 -8.57211 -16.2038 -1741 4 9.93935 20.7152 41.5745 -5.21063 7.9265 20.924 -1742 4 8.4582 20.7874 41.6647 -18.4316 -1.36421 1.54976 -1743 6 7.41915 26.897 34.8578 6.273 24.0322 40.4596 -1744 4 7.07209 27.1094 35.7714 11.2799 -9.18849 -34.7736 -1745 4 6.87885 26.1925 34.5434 -18.5272 -22.724 -11.5995 -1746 6 18.6237 10.1563 3.02822 -55.9716 37.9013 1.68891 -1747 4 17.9823 9.44023 2.87563 14.9297 4.34306 1.98909 -1748 4 18.009 10.9755 3.18254 40.8652 -32.8317 -2.61569 -1749 6 13.1455 21.2337 25.2154 -14.3081 5.93545 -14.9534 -1750 4 12.8153 21.6822 24.4216 9.6722 -4.26313 4.93127 -1751 4 12.7862 20.3541 25.1726 -3.49479 -14.4912 -0.313259 -1752 6 4.91031 24.4198 40.532 -13.7809 -26.5024 -53.169 -1753 4 5.65778 24.4539 41.0894 26.3299 12.2697 26.6549 -1754 4 5.26856 23.9753 39.7091 -18.4358 16.5303 24.5031 -1755 6 54.7198 6.2862 9.93073 18.558 2.67796 -18.7732 -1756 4 54.1336 6.00192 10.611 -15.308 -5.80798 23.6242 -1757 4 0.005563 7.17106 10.1764 0.43073 7.36928 5.10877 -1758 6 51.7604 16.6436 19.3877 -20.3234 -7.55047 -14.8495 -1759 4 51.6779 16.1639 18.5383 1.1676 14.9854 4.84802 -1760 4 52.2077 17.4816 19.2574 16.3674 3.30585 -9.00164 -1761 6 38.6218 2.96001 13.0988 15.7387 3.67705 55.5859 -1762 4 38.6299 3.43096 13.9849 -4.06073 -12.9308 -23.724 -1763 4 38.2169 3.56793 12.5083 -12.8186 19.7945 -24.9943 -1764 6 19.4471 35.7007 9.61167 2.35324 -8.95281 6.35471 -1765 4 18.8335 36.2871 9.19379 -17.9936 2.63552 -14.7984 -1766 4 18.9495 35.3837 10.3842 8.56204 6.47345 -9.11173 -1767 6 46.9457 37.6212 25.7021 -15.6754 4.57489 10.5165 -1768 4 47.0239 38.0262 24.8354 11.6036 -0.197794 -10.4287 -1769 4 47.7281 37.1166 25.9279 8.14222 -0.129186 -6.11913 -1770 6 20.0249 17.2708 14.7582 9.34392 -2.11639 -6.02108 -1771 4 19.1723 17.4786 15.1706 12.7461 -0.873648 3.80655 -1772 4 20.7009 17.0069 15.4035 -13.3418 2.74043 0.572405 -1773 6 24.7358 29.2923 3.78206 18.5642 -33.4808 -47.1325 -1774 4 24.7422 28.3915 3.3709 -13.1038 11.8323 28.3161 -1775 4 25.3506 29.6775 3.14782 -2.77927 21.1078 10.4189 -1776 6 3.43141 8.92567 6.82668 25.8011 -1.75535 29.9445 -1777 4 3.08486 8.82716 7.75964 16.0017 4.22665 -30.6726 -1778 4 4.42441 9.10783 6.89545 -42.5611 -5.30748 1.54274 -1779 6 17.4891 30.59 19.7026 37.1524 -11.5388 -6.241 -1780 4 18.4343 30.3591 19.4199 -38.2372 10.1448 10.4771 -1781 4 16.9657 29.7875 19.5831 -4.14236 3.18225 -9.29444 -1782 6 13.2748 16.1833 39.0603 8.39615 -10.6604 2.01333 -1783 4 13.778 16.9491 39.3364 8.93523 3.59341 7.63718 -1784 4 12.5498 16.5465 38.5646 -17.693 7.52452 -10.3405 -1785 6 23.8419 27.9652 11.5971 -29.0622 15.8949 5.8355 -1786 4 23.0433 27.5239 11.9581 15.8216 -1.64981 -8.50246 -1787 4 23.6687 28.8945 11.8451 9.38175 -9.8305 -3.59643 -1788 6 14.4582 24.411 21.2251 -13.2323 27.0215 19.0701 -1789 4 13.9163 25.2229 21.3861 13.2503 -9.35589 -12.2275 -1790 4 14.348 23.9323 22.0593 -1.27999 -3.95586 -5.82862 -1791 6 46.6209 15.1404 22.2877 -21.0909 8.30909 34.5316 -1792 4 45.8336 14.7024 21.9608 7.3328 -3.88381 -14.3297 -1793 4 47.2246 15.4169 21.6106 10.5055 -5.27886 -22.0515 -1794 6 19.1453 29.7169 11.8746 -27.0123 -18.8736 -35.9167 -1795 4 18.7667 30.5363 11.5796 10.8323 29.6783 4.39578 -1796 4 18.5214 29.1838 11.3275 23.3568 -13.7991 20.8336 -1797 6 36.9132 18.8016 27.615 -17.0652 -23.8487 30.8874 -1798 4 36.4034 18.4868 26.8464 6.26881 1.65463 6.80847 -1799 4 36.6041 18.1666 28.3506 10.215 31.7365 -33.4968 -1800 6 35.8839 17.5137 25.5036 -5.81764 30.7264 -16.7466 -1801 4 36.5665 17.9094 24.9 -10.7703 -22.5287 9.19997 -1802 4 35.9135 16.5474 25.44 8.68204 5.15754 -2.43364 -1803 6 8.04468 41.8981 31.5366 26.4021 9.77217 -3.38911 -1804 4 8.66886 41.284 31.9946 -24.4733 15.0027 -13.0466 -1805 4 8.60227 0.704634 31.1522 -11.4596 -14.2431 6.13083 -1806 6 31.7024 34.8356 17.9299 26.5575 -27.0845 -4.88708 -1807 4 32.6196 34.4986 17.7931 -22.3662 0.836155 -3.84042 -1808 4 31.9071 35.6664 18.3392 -5.09232 26.8034 6.09861 -1809 6 22.0993 41.0535 5.13739 10.0927 40.3608 -89.4928 -1810 4 22.1435 40.6782 5.94278 2.96748 -46.7441 88.004 -1811 4 22.8097 40.6452 4.60918 -8.49191 2.25551 6.5005 -1812 6 11.6188 5.17183 29.5438 -37.4391 -17.3681 45.4318 -1813 4 12.0782 4.3477 29.7115 12.4576 1.56532 -11.0695 -1814 4 10.8376 5.06958 30.1835 21.3256 14.0691 -33.8944 -1815 6 13.0142 9.45267 21.0738 -17.3871 -39.5803 -33.4019 -1816 4 13.648 9.91302 21.5572 37.1542 33.3127 26.6408 -1817 4 13.4951 8.71823 20.6397 -14.9934 11.5246 2.17133 -1818 6 12.4259 4.16416 0.171584 25.5917 58.0572 -18.9009 -1819 4 12.7038 3.75631 0.988868 -0.121161 -3.62646 8.37405 -1820 4 12.9914 5.02921 0.073462 -27.1162 -49.1387 2.0493 -1821 6 45.1548 14.6294 28.1056 43.5869 -15.7342 -2.79686 -1822 4 45.3799 14.9442 27.2254 -14.4652 2.82802 -6.08545 -1823 4 46.001 14.1543 28.294 -26.1128 6.03561 5.66217 -1824 6 52.5819 19.2522 0.880939 -13.6546 -24.4625 3.21793 -1825 4 52.4967 19.3157 41.8353 6.16951 -6.72877 -2.3034 -1826 4 52.7342 20.1258 1.1855 8.55196 28.2584 6.16427 -1827 6 0.17636 18.5769 30.5692 -13.5341 -21.3209 11.3545 -1828 4 0.97347 18.6538 30.0344 3.16555 8.74201 -0.550561 -1829 4 54.7381 19.4288 30.6755 1.51483 11.9419 -1.05075 -1830 6 17.6474 28.1849 1.96582 -3.95698 7.79984 2.09024 -1831 4 17.0036 28.8884 1.72628 7.01161 -11.1903 7.18073 -1832 4 17.5665 28.0879 2.93205 1.48476 5.36119 -8.9874 -1833 6 22.5179 30.1562 5.01973 -0.557011 13.5756 -11.2394 -1834 4 23.053 30.1464 4.21842 7.71181 1.56353 5.86697 -1835 4 22.1417 29.2826 4.9966 -11.5089 -8.75783 6.0437 -1836 6 11.3992 8.80614 17.6425 18.8049 17.2909 -5.92301 -1837 4 12.0044 8.1818 18.0403 -8.94801 -14.7479 17.6102 -1838 4 12.0653 9.44286 17.3244 -18.8797 1.15675 -4.46111 -1839 6 32.2825 3.5901 26.8335 38.6865 42.7422 0.354813 -1840 4 31.9744 3.38447 25.9652 -16.937 -9.17442 -22.5821 -1841 4 32.8531 4.41036 26.697 -18.7333 -32.0278 -1.10411 -1842 6 26.8283 37.1448 15.664 9.9544 44.9512 -6.81835 -1843 4 26.832 37.6522 16.5019 -4.80771 -22.2764 -7.00776 -1844 4 26.708 36.2069 15.7377 -4.77442 -21.1488 11.5765 -1845 6 22.9466 3.40402 22.281 26.551 -3.46013 -1.27592 -1846 4 23.3626 3.00539 21.4748 -15.0613 6.75 14.6032 -1847 4 23.702 3.67884 22.8406 -14.5661 -4.86975 -12.1571 -1848 6 14.6187 28.2219 5.2011 12.2375 -1.31522 5.54773 -1849 4 14.146 28.1316 4.37141 -5.71124 1.87741 -8.30492 -1850 4 14.2863 29.0052 5.66137 -0.824291 -0.470469 -2.06805 -1851 6 20.2555 37.1856 16.5486 -24.9193 16.4856 21.7008 -1852 4 21.0596 37.4718 16.144 26.6499 6.5165 -11.4453 -1853 4 20.1477 37.8155 17.2956 -4.48599 -12.7862 -6.90992 -1854 6 17.9469 28.5629 23.8891 26.0841 -15.2841 -12.8531 -1855 4 18.7956 28.2639 23.4837 -20.5944 5.95667 14.8805 -1856 4 17.3322 27.8283 23.7208 -3.07308 9.52654 -1.59768 -1857 6 33.6454 24.2344 25.2281 6.08515 -19.3492 9.67379 -1858 4 33.7229 23.2583 25.1621 -7.7165 13.5894 -11.682 -1859 4 33.9838 24.3464 26.1231 0.527101 9.69022 -3.14208 -1860 6 9.99248 17.6305 2.22889 -2.94775 -31.1618 -12.577 -1861 4 10.7668 17.5307 1.6348 -7.17319 1.58445 12.7603 -1862 4 9.8062 16.7546 2.64219 6.61617 15.6433 -4.64734 -1863 6 24.3378 36.7975 8.92134 10.0949 -17.5556 18.6285 -1864 4 24.0798 37.5812 8.46711 -7.4438 24.0622 -5.98172 -1865 4 24.7733 37.0584 9.7453 -6.84359 -4.10885 -5.58351 -1866 6 14.3929 4.30304 27.7402 56.7365 -3.53996 19.7179 -1867 4 15.3546 4.44499 27.4586 -37.3153 -7.57895 7.00929 -1868 4 13.8272 4.37832 26.9899 -16.116 5.01688 -19.8092 -1869 6 13.2096 25.4586 35.3298 -3.87145 -6.51473 -10.8119 -1870 4 13.1476 25.2267 36.278 -1.83966 -3.78777 -13.8323 -1871 4 12.5545 24.9939 34.7684 5.09589 5.85633 19.2997 -1872 6 43.7315 33.1816 24.4051 17.2004 -9.02075 24.8986 -1873 4 44.3591 33.0681 25.1678 -20.1541 -6.26738 -17.3644 -1874 4 44.1096 33.9146 23.9227 -1.6352 8.32092 -8.69406 -1875 6 6.97009 30.4077 7.13769 23.121 1.43384 34.0809 -1876 4 6.71282 29.9591 7.9596 7.06976 3.62274 -2.26904 -1877 4 6.20421 30.2819 6.61977 -27.9511 -2.76807 -27.2062 -1878 6 44.437 39.4145 21.7835 -9.43682 11.6365 -18.5611 -1879 4 43.878 39.1032 21.0489 1.92512 -11.9494 17.5009 -1880 4 44.878 40.1639 21.3648 8.44417 -6.89071 6.17346 -1881 6 1.1648 16.4475 24.9778 -2.61131 5.39938 13.1681 -1882 4 1.07525 17.0286 24.1819 -7.88043 -13.0173 22.3573 -1883 4 0.434843 16.5677 25.6378 18.4556 1.9359 -28.7216 -1884 6 8.16988 33.8361 10.6637 16.6829 23.9256 47.7562 -1885 4 8.49559 33.5478 9.83195 -4.50358 -22.2449 -29.7436 -1886 4 7.35799 33.4028 10.9227 -18.4601 -13.1254 -8.86092 -1887 6 45.3716 15.8699 40.491 -6.36942 -3.03704 -2.15917 -1888 4 44.5133 15.7719 40.0601 4.63234 -6.98635 -0.416374 -1889 4 45.243 16.6248 41.0649 5.7116 1.92459 5.42472 -1890 6 38.7776 4.29245 15.9056 11.0795 0.30753 4.41463 -1891 4 39.6766 4.00679 16.0952 1.69097 -2.92337 -3.33067 -1892 4 38.5504 4.73291 16.7401 -7.14778 -2.92142 -9.36231 -1893 6 21.0846 9.20759 23.9691 5.60032 -0.18462 4.18544 -1894 4 20.9445 8.65571 23.1711 -3.69603 16.8592 7.46004 -1895 4 20.5672 10.0363 23.9442 1.93643 -14.5945 -11.3561 -1896 6 6.46938 36.1391 20.0069 4.0004 4.10087 4.13062 -1897 4 5.99357 35.3124 19.8297 -2.3473 7.0562 -2.30419 -1898 4 7.3052 35.893 20.4098 -0.600933 -5.92452 -3.30983 -1899 6 17.7588 23.4635 11.2444 16.528 -28.2646 53.7307 -1900 4 16.9432 23.8548 11.0264 -32.805 26.4079 -23.7501 -1901 4 17.621 23.3206 12.2167 9.32529 -0.814156 -28.2078 -1902 6 2.23938 39.2705 23.5372 32.4488 -19.3396 -21.3039 -1903 4 2.96143 39.1072 24.212 -19.8533 -4.03587 -26.9428 -1904 4 2.57592 39.0525 22.6024 -11.4643 11.6849 46.2914 -1905 6 21.7189 10.3135 3.08585 -2.90529 19.7604 61.578 -1906 4 21.843 10.1221 2.19424 -0.974385 -17.6276 -55.1642 -1907 4 20.7734 10.4085 3.28686 2.80557 -4.86174 -11.6796 -1908 6 13.3371 37.6485 26.8148 34.7445 -2.08205 -3.58175 -1909 4 12.7942 37.01 27.2655 -5.666 -15.7112 8.11946 -1910 4 14.1995 37.1812 26.5945 -31.1056 12.6209 6.4215 -1911 6 45.679 9.86525 8.82671 -1.22844 -5.97168 -0.0165319 -1912 4 45.3204 9.57969 7.98479 1.29945 7.51218 -9.52666 -1913 4 45.2548 9.27624 9.44517 -6.37871 -3.09075 9.62419 -1914 6 39.8117 32.343 29.5858 -3.04799 14.0722 -9.88422 -1915 4 39.6223 31.4471 29.2796 3.58631 -7.81261 7.71305 -1916 4 40.3439 32.3214 30.3816 0.770365 -10.1242 2.16071 -1917 6 39.1301 32.1592 8.96473 45.9624 -7.76569 -23.2306 -1918 4 39.6852 32.0596 8.1252 -31.4186 4.60772 35.1501 -1919 4 38.2007 32.2042 8.75798 -9.66602 0.778467 -8.76952 -1920 6 29.7501 11.3103 40.3404 42.6438 -12.6008 -10.1865 -1921 4 29.0692 10.6634 40.5326 -1.99158 -8.72077 -0.363163 -1922 4 30.6164 10.7842 40.3158 -34.6338 15.486 -0.0451708 -1923 6 24.8345 19.8801 29.8412 -7.59088 37.7695 16.0848 -1924 4 24.9026 19.0378 30.268 -1.65451 -21.4471 9.48031 -1925 4 24.5694 20.5293 30.547 8.64688 -23.6335 -15.2845 -1926 6 50.0799 29.4689 2.86832 11.3398 7.37373 -14.0975 -1927 4 50.7937 29.3382 3.51213 -5.95266 6.62042 -8.33887 -1928 4 50.5172 29.4209 1.98721 -16.9062 -3.16045 21.5768 -1929 6 26.3158 13.2487 37.9516 44.6834 6.62304 1.7852 -1930 4 27.2667 13.2121 37.7291 -19.4356 -10.4808 -19.3263 -1931 4 26.4654 13.336 38.8817 -25.2145 10.5198 25.1195 -1932 6 24.3285 13.817 16.1492 -2.87417 -29.0242 -9.8062 -1933 4 24.8278 14.0306 16.9324 2.95884 13.8503 11.1204 -1934 4 24.1796 14.5912 15.6032 1.91347 13.6823 2.96602 -1935 6 21.9624 25.0824 8.00452 15.4008 12.078 14.6814 -1936 4 22.598 25.7039 7.58094 -6.50256 -15.9793 3.04336 -1937 4 22.4506 24.6482 8.74092 -7.92214 9.81208 -17.5113 -1938 6 50.1646 25.295 29.0323 7.20414 -13.325 -13.2678 -1939 4 50.9752 25.188 28.522 -3.46618 -9.57224 -11.582 -1940 4 50.4808 25.9292 29.6536 -4.58067 20.151 23.6328 -1941 6 23.186 6.81871 7.63171 8.52809 43.4321 -4.70249 -1942 4 24.005 7.36604 7.81791 -26.2659 -19.6382 -4.15731 -1943 4 22.4749 7.49932 7.50679 12.9101 -23.886 0.0924589 -1944 6 6.93738 5.85096 20.8328 -1.25739 23.0019 -5.42089 -1945 4 7.49016 6.65136 20.6793 -8.05782 -22.0664 2.33926 -1946 4 6.43567 5.73489 20.0135 6.68134 -11.6114 -0.0369962 -1947 6 25.4027 39.7503 23.9523 -6.31967 32.2782 -31.5462 -1948 4 25.6215 38.8259 24.0292 3.86532 -10.8289 -5.32001 -1949 4 25.5293 40.0494 22.9984 1.78505 -20.5244 33.6821 -1950 6 10.8465 30.682 2.12076 -14.9417 -4.95607 29.3443 -1951 4 9.91334 30.8811 2.27771 3.65307 -4.25506 9.47201 -1952 4 11.0492 31.2188 1.38489 10.4343 12.2811 -36.8692 -1953 6 23.0846 40.5263 40.0577 -14.1833 12.856 -13.2149 -1954 4 23.7732 40.7716 39.4116 -4.4893 -4.99974 3.24897 -1955 4 22.2685 41.0049 39.7737 14.5189 -12.3092 -2.05606 -1956 6 29.2062 28.3669 37.5673 -46.9973 46.4688 -26.4511 -1957 4 28.2092 28.447 37.3765 47.4284 -5.55714 9.99444 -1958 4 29.3363 27.5265 37.9547 9.31284 -31.0764 15.334 -1959 6 1.86163 12.1711 18.0765 -5.91003 5.49035 -5.71632 -1960 4 2.55659 11.9166 18.6527 25.6221 -14.4574 8.12849 -1961 4 1.26079 12.5379 18.7153 -20.6967 6.08864 -3.03965 -1962 6 35.8475 14.1052 8.57203 -21.6385 -0.893463 -33.3774 -1963 4 35.1968 13.4152 8.63145 -9.00219 -13.9675 31.2536 -1964 4 35.5915 14.3843 7.67264 23.8052 12.2531 2.11843 -1965 6 9.47935 39.8135 37.5891 59.0759 6.31763 -30.1219 -1966 4 10.4266 39.6693 37.2666 -35.8633 -8.68454 26.4626 -1967 4 9.26489 40.5592 37.0217 -20.4655 -4.29881 5.22341 -1968 6 3.55142 30.3339 19.2713 -4.86381 -1.52132 15.3498 -1969 4 4.33638 30.9045 19.2209 2.57405 -7.87202 3.73908 -1970 4 3.61239 29.7873 20.0935 6.99099 14.0083 -17.3235 -1971 6 36.3358 32.3745 17.56 -88.747 -21.2483 -18.3477 -1972 4 37.1123 32.7301 17.855 71.5568 29.0637 22.2427 -1973 4 36.4955 31.7908 16.8209 7.92507 -6.87638 -5.35096 -1974 6 22.0663 24.5107 41.4102 10.2987 16.3962 12.7497 -1975 4 21.8202 25.2352 0.099599 7.35269 -2.74787 -1.24985 -1976 4 21.4331 24.5495 40.7007 -15.7672 -0.145359 -12.6123 -1977 6 45.7559 15.6146 11.6534 9.54961 -0.52573 -11.8143 -1978 4 46.6616 15.9476 11.7359 -2.85604 3.39399 3.95489 -1979 4 45.8337 14.6574 11.6049 5.18085 -12.4794 -2.56515 -1980 6 22.3677 20.3608 16.0248 -8.43349 0.762232 -3.33301 -1981 4 21.8453 20.4382 16.8206 -16.1556 -9.64869 10.2413 -1982 4 23.0114 21.0388 16.1556 20.3116 20.3082 3.24798 -1983 6 25.8272 25.7408 18.9039 -4.38174 23.1082 -8.64826 -1984 4 25.2526 26.4897 18.6396 10.1677 -11.9346 2.39614 -1985 4 25.327 25.3554 19.6213 -1.60311 -10.6753 3.35926 -1986 6 35.3217 34.2027 33.2895 -15.2368 -41.9721 4.95923 -1987 4 35.4982 35.1152 33.2737 3.10328 43.0158 -1.14622 -1988 4 34.4946 34.1251 33.8 0.780353 -3.85018 -10.6306 -1989 6 39.2773 17.1161 17.3873 -13.1248 -32.2738 -8.05101 -1990 4 39.9918 17.6798 17.5739 28.094 23.6652 8.23643 -1991 4 38.688 17.6273 16.829 -11.1713 3.07886 5.75329 -1992 6 0.390078 14.9382 21.7871 11.1367 4.76555 -0.935352 -1993 4 54.4387 14.8735 21.5807 -4.47162 2.48431 -1.07762 -1994 4 0.539841 14.2564 22.4568 -0.558284 -6.24417 -4.29591 -1995 6 15.9777 23.2264 17.7728 8.65625 13.1041 -6.34263 -1996 4 15.4566 22.9884 16.9791 5.52796 1.00784 5.82867 -1997 4 16.2806 24.159 17.6616 -10.6082 -13.1932 5.11686 -1998 6 5.23931 11.1231 17.5575 35.8701 -10.5445 17.9772 -1999 4 4.9182 10.2425 17.6538 -30.0926 -10.858 -8.95801 -2000 4 6.0864 10.9521 18.0214 -7.64643 27.0942 -5.06777 -2001 6 9.32885 36.7248 13.2722 18.9931 -22.2768 -8.23823 -2002 4 9.60165 35.7781 13.2295 -3.69965 14.6724 -0.704445 -2003 4 9.76236 37.1699 12.5317 -7.58045 -2.70049 0.515103 -2004 6 25.4778 33.5648 0.584885 -10.5355 67.2754 -12.4068 -2005 4 25.5984 34.5208 0.879361 -11.6997 -30.6233 -9.64051 -2006 4 26.086 33.1118 1.1181 20.4991 -31.2317 29.3626 -2007 6 17.3118 24.383 31.3319 -1.28664 6.54307 -2.76395 -2008 4 17.7194 25.1777 30.9449 -5.40799 -4.17061 0.343513 -2009 4 16.6541 24.6578 31.9842 -4.89885 3.77294 -0.581941 -2010 6 50.5608 32.7082 27.7934 4.54158 -2.94952 -18.7634 -2011 4 50.7453 32.9177 28.6973 0.494052 11.2961 18.8161 -2012 4 49.6536 32.9735 27.676 -15.0266 -0.0998574 -2.84245 -2013 6 2.26734 37.236 16.1173 -6.42813 -12.7591 -21.9136 -2014 4 3.23226 37.3187 16.1136 -7.03488 -2.64717 4.42174 -2015 4 1.90002 37.4962 16.9584 8.86323 8.39289 12.7736 -2016 6 25.781 33.1953 8.40059 -29.5389 -21.3471 9.61313 -2017 4 24.912 33.1588 8.86731 13.6407 4.32372 -10.5279 -2018 4 25.7521 32.4014 7.84509 3.14784 4.30114 -1.53431 -2019 6 24.7803 7.83271 25.42 33.5144 32.018 13.9598 -2020 4 25.5535 8.29724 25.0002 -28.4293 -10.6828 16.5011 -2021 4 24.3491 7.42211 24.7041 -24.9556 -17.4551 -27.4815 -2022 6 44.0168 27.3303 21.5604 -2.1935 -26.0293 -25.9567 -2023 4 43.1804 27.7287 21.7105 -15.5436 25.6402 11.6584 -2024 4 43.7182 26.5374 21.0766 16.4483 6.01939 6.04345 -2025 6 20.8314 32.075 6.72772 34.1297 -23.9008 -4.85338 -2026 4 21.613 31.4679 6.7544 -19.7741 14.5872 -14.4381 -2027 4 20.6476 32.1788 7.6576 -7.69651 14.1485 11.3249 -2028 6 0.619789 26.0994 3.99415 -10.3518 14.1264 10.767 -2029 4 0.887335 25.4928 3.30986 5.36048 -13.1936 -7.97543 -2030 4 1.24971 25.9998 4.71308 0.85353 -1.82089 -1.56654 -2031 6 23.69 0.227417 22.8544 35.0871 1.11343 17.3571 -2032 4 23.3906 1.11513 23.0752 -8.28129 -2.57498 -6.74336 -2033 4 24.6181 0.214091 23.2237 -29.0994 -2.98435 -11.3486 -2034 6 35.6339 26.9438 6.46453 10.8918 50.3879 3.14258 -2035 4 36.2586 27.0344 7.19591 -3.09793 -24.7425 -0.485193 -2036 4 35.6905 27.8753 6.10871 -13.1004 -35.3011 6.52721 -2037 6 50.1792 7.09321 18.6927 -10.3798 0.485236 0.91939 -2038 4 50.7755 7.39768 17.9917 2.23399 -7.26744 -1.07457 -2039 4 49.6856 7.89728 18.8977 2.66313 1.30029 -2.34319 -2040 6 12.4725 14.8259 12.1994 -11.4238 -12.6169 14.8051 -2041 4 11.6664 14.488 12.6556 18.5487 5.78377 -7.93059 -2042 4 12.1518 15.362 11.4889 -6.75978 6.85562 -13.2996 -2043 6 52.4644 22.357 36.3266 1.29806 9.96622 10.4358 -2044 4 51.6029 21.898 36.3064 11.3287 0.910024 -15.7837 -2045 4 53.0734 22.0059 35.6434 -17.6122 -2.36697 5.80151 -2046 6 41.7741 11.4843 39.1248 -4.39753 -8.31887 -97.8346 -2047 4 42.1028 11.6824 39.9378 27.3537 17.7413 77.2645 -2048 4 42.4804 11.7867 38.4877 -22.5072 -9.73773 16.9601 -2049 6 13.8016 22.5118 39.1095 -61.9889 -17.7515 -30.6487 -2050 4 12.8197 22.2903 39.2632 45.6803 12.2331 1.0283 -2051 4 13.898 22.318 38.1378 10.5436 5.15112 27.5343 -2052 6 28.757 19.5278 21.8422 22.1809 -34.574 6.30338 -2053 4 29.5381 18.8977 21.7155 -30.335 22.4331 6.48321 -2054 4 28.5907 19.9346 20.9925 4.65837 4.37905 -10.6157 -2055 6 8.3499 21.6369 36.3971 -4.18721 -6.14707 -6.4426 -2056 4 8.67403 22.5346 36.3601 -3.60933 11.4321 4.1017 -2057 4 7.70004 21.5677 37.1222 1.54916 7.87236 -6.53046 -2058 6 39.9526 23.9745 15.2115 13.6309 -13.3423 -31.903 -2059 4 40.8439 23.5703 15.3899 -24.3155 14.8143 -11.3375 -2060 4 39.7878 23.9253 14.2154 4.70535 3.62281 36.021 -2061 6 8.1527 38.6897 22.5283 9.69445 13.3876 41.2978 -2062 4 7.76273 39.4363 22.0797 -11.7526 5.15604 -12.9046 -2063 4 8.4358 39.1168 23.3873 -5.25998 -17.8667 -18.7912 -2064 6 10.8496 20.1728 28.9641 16.4592 -1.26099 15.6701 -2065 4 9.98954 19.7606 29.0198 -7.88942 -4.93169 1.40711 -2066 4 10.9743 20.477 28.0788 -3.54014 6.836 -18.3013 -2067 6 36.8958 23.8215 41.8184 -11.2791 50.4956 -15.8947 -2068 4 37.6092 23.2626 0.106032 31.5333 -36.7229 14.8491 -2069 4 36.0533 23.398 41.8576 -15.1401 -19.7994 6.87638 -2070 6 23.7844 40.6753 33.3645 25.4398 -8.90266 -26.6636 -2071 4 23.0047 40.9559 33.8219 -17.4738 3.31201 10.6553 -2072 4 23.8864 39.707 33.5122 -4.88896 17.7845 5.86364 -2073 6 4.67086 19.2968 35.4027 23.2175 14.2952 24.1117 -2074 4 5.52557 19.1329 35.8895 -25.1286 -0.194605 -14.6261 -2075 4 4.47498 18.5363 34.8535 5.06934 -11.7578 -4.1199 -2076 6 9.45318 25.7818 10.8943 -12.0967 -8.54473 -2.48434 -2077 4 9.17249 24.8577 10.8042 5.18757 -1.88658 7.00696 -2078 4 8.69489 26.2739 10.5541 4.04726 3.8113 4.64502 -2079 6 27.2856 22.4903 13.6084 -4.27813 -9.26261 -11.4963 -2080 4 27.1477 21.7546 14.2243 0.799228 0.372191 -1.31996 -2081 4 27.4324 22.0688 12.7356 2.14896 10.5831 15.5277 -2082 6 41.0369 18.7679 23.2817 21.3973 -17.1333 -11.6606 -2083 4 40.4805 18.1775 22.7581 -1.93352 7.79722 7.02989 -2084 4 40.5302 19.4817 23.6332 -16.07 12.1618 6.58845 -2085 6 46.4867 28.3511 20.139 19.5633 -2.73425 79.1757 -2086 4 45.7489 28.0125 20.7058 1.11057 9.83041 -23.9354 -2087 4 47.2126 28.3766 20.859 -22.6454 6.05643 -47.0217 -2088 6 14.8422 15.3983 30.0672 9.57922 -13.7488 21.5316 -2089 4 14.7114 15.4303 29.1407 -5.18406 2.12307 -31.6519 -2090 4 14.4223 14.5569 30.327 1.67929 11.6926 7.32181 -2091 6 23.5155 24.7614 35.2027 10.8097 10.1661 11.7756 -2092 4 22.8249 25.3921 35.4883 8.74662 -8.07224 -2.50931 -2093 4 24.264 24.8574 35.8273 -14.1502 1.20627 0.95778 -2094 6 19.9045 24.2066 28.4368 -7.08314 38.6572 -15.5481 -2095 4 20.1199 25.09 27.9887 -7.53461 -31.417 18.3002 -2096 4 18.948 24.2479 28.615 8.77669 -1.27719 -1.90381 -2097 6 45.9703 7.63062 20.2339 -9.12647 -14.8446 45.7383 -2098 4 46.0314 7.87281 21.2057 4.66889 -10.1155 -32.2433 -2099 4 46.2124 8.39508 19.7344 6.23892 21.3693 -9.48098 -2100 6 38.0366 12.4686 8.28298 -82.8488 23.4696 -21.0017 -2101 4 37.3097 13.1608 8.47894 48.7672 -25.4087 1.47773 -2102 4 37.4891 11.9231 7.63396 42.6716 2.94367 19.7224 -2103 6 46.9352 18.181 8.45984 -29.3266 9.95329 16.0714 -2104 4 46.1825 17.5598 8.49993 9.84889 1.25457 2.04897 -2105 4 47.3911 17.9594 7.65971 14.7535 -7.6497 -21.4463 -2106 6 10.8592 13.9727 9.37152 -3.14543 -2.30259 -2.26695 -2107 4 10.3309 14.6626 8.91794 11.6563 -8.1882 2.6931 -2108 4 11.7607 13.9013 8.99546 -12.5287 13.781 2.06755 -2109 6 34.3902 5.43491 14.0826 12.6346 -17.837 -1.14204 -2110 4 35.1666 5.80709 13.6695 9.45544 21.1547 -1.41353 -2111 4 34.3397 4.58795 13.6148 -10.7305 -5.41844 9.88093 -2112 6 0.19016 0.223418 22.9526 3.77382 -24.7853 -3.01602 -2113 4 0.21308 41.6498 22.1069 2.59646 7.80057 12.2766 -2114 4 54.882 1.08863 22.7473 -12.4607 27.7599 -7.08256 -2115 6 40.9349 30.5562 37.8906 -27.573 -19.5948 34.9696 -2116 4 40.0494 30.8463 38.2359 23.4276 0.414778 -20.0189 -2117 4 41.1198 29.7844 38.4793 13.2677 19.1991 -19.1849 -2118 6 16.6358 17.3088 12.6818 26.7235 26.3695 -9.20965 -2119 4 16.2617 16.4703 12.4231 -8.92935 -8.7699 -0.695474 -2120 4 17.0088 17.6771 11.8494 -7.35458 -7.68048 15.4997 -2121 6 29.681 5.43286 24.7605 9.99716 1.48249 -7.0405 -2122 4 30.3348 5.91815 24.2382 -0.696307 0.629534 -2.6419 -2123 4 30.0075 5.55596 25.6632 -4.07672 -1.78023 1.29455 -2124 6 49.8902 0.287541 27.2058 21.9743 -13.7053 4.20571 -2125 4 49.8511 0.519591 26.2742 -5.37584 5.48457 -4.26768 -2126 4 50.7946 41.8257 27.2858 -12.157 4.98657 1.57708 -2127 6 31.2412 31.7366 15.2127 13.4193 29.9729 -4.01619 -2128 4 31.644 30.8863 15.3566 3.05611 -13.2507 6.82249 -2129 4 31.9953 32.37 15.1128 -22.0385 -12.9049 3.52444 -2130 6 35.7903 24.1511 16.9464 13.6459 1.10276 -6.74723 -2131 4 35.6731 24.9832 16.4455 1.01595 -13.8109 1.97492 -2132 4 36.7089 23.8312 16.7527 -22.9866 2.97508 8.81266 -2133 6 24.2751 4.63968 36.7374 -16.5997 -22.3051 -33.4925 -2134 4 24.7608 5.22686 37.2962 14.6544 10.0168 10.4919 -2135 4 24.7016 4.68474 35.8573 -7.94113 -0.389021 16.9181 -2136 6 17.5636 12.9031 3.65869 27.6744 1.86844 -28.0383 -2137 4 17.6858 13.5605 2.94059 1.9993 -16.4932 11.4828 -2138 4 16.8984 13.3068 4.18363 -27.8054 1.98581 18.3397 -2139 6 4.17446 14.2934 18.2709 12.2351 -24.5699 -15.5283 -2140 4 4.25201 13.3082 18.1842 -5.45348 23.7329 4.34334 -2141 4 3.28482 14.5076 18.5604 -13.4286 -3.54266 5.37394 -2142 6 19.1793 36.8557 22.3908 -6.26797 4.12828 -2.16449 -2143 4 18.7803 36.3059 23.064 -4.74301 -7.71326 18.3965 -2144 4 19.5341 36.2254 21.7686 7.87239 -11.0625 -9.31555 -2145 6 15.659 11.9578 13.1999 9.98626 24.0921 3.91449 -2146 4 15.6233 12.8387 12.7526 3.08695 -23.3335 12.0049 -2147 4 16.532 11.8904 13.6603 -13.5492 -1.68197 -15.0215 -2148 6 24.7583 21.9129 5.36621 -52.0449 4.43235 28.4012 -2149 4 24.9756 21.6947 6.28233 10.5491 3.37037 -1.58044 -2150 4 23.7611 21.9216 5.43181 35.5612 -5.35731 -13.8865 -2151 6 52.741 18.5708 35.2268 19.1809 2.02674 5.12186 -2152 4 52.5591 18.101 34.4104 -23.468 -7.47943 -3.72799 -2153 4 51.9957 18.6447 35.8177 -20.5936 -5.49273 0.0575333 -2154 6 3.56038 27.2788 25.2921 -16.6903 -17.6792 -11.4043 -2155 4 3.96469 27.2185 26.149 7.10467 -3.13705 18.347 -2156 4 3.97939 27.9962 24.8424 10.8751 21.6711 -8.62461 -2157 6 34.4448 32.9974 30.68 48.2331 9.00339 -1.41906 -2158 4 33.5189 32.8245 30.8394 -9.09046 9.48004 8.12592 -2159 4 34.8804 33.6211 31.3233 -29.3839 -17.782 -5.29467 -2160 6 35.2611 23.7526 9.83248 5.28039 9.63542 14.9856 -2161 4 34.4624 23.9143 9.32096 3.45609 1.41047 -6.97204 -2162 4 35.624 22.9154 9.5528 3.26088 -11.8232 -8.34585 -2163 6 42.4243 15.7233 8.97763 12.8326 1.39623 12.6931 -2164 4 41.658 15.328 8.60072 -22.8346 -8.994 -22.1277 -2165 4 42.104 15.9534 9.85586 1.77226 3.68974 5.84069 -2166 6 7.76866 28.8533 32.9548 -11.0049 17.2013 -15.4709 -2167 4 8.04862 28.1203 33.4848 1.42969 -15.0059 16.0601 -2168 4 8.50079 29.0495 32.3677 8.58058 4.20069 -3.59376 -2169 6 17.6953 41.2515 36.4663 -11.3067 -18.3758 74.5383 -2170 4 16.8889 41.7296 36.6796 -1.19906 6.43806 -6.60961 -2171 4 17.8689 41.3412 35.574 12.2332 11.1792 -57.8962 -2172 6 28.5157 24.2416 15.5518 -29.4686 -13.3801 -11.1317 -2173 4 29.0166 24.9984 15.2559 10.2779 3.66755 -9.57255 -2174 4 28.1226 23.7858 14.7645 18.214 7.11075 11.8426 -2175 6 20.955 16.2999 1.15679 52.4547 14.172 -5.31351 -2176 4 20.9215 15.3848 1.33551 1.21723 -32.5558 11.4722 -2177 4 20.0795 16.5686 1.08505 -57.8144 13.7968 -3.85053 -2178 6 31.1684 40.7359 5.3086 9.60886 -48.7905 -14.3252 -2179 4 30.3201 40.4364 4.96776 -1.1434 5.1051 1.34806 -2180 4 31.1111 41.6485 5.46945 -11.8258 44.905 11.395 -2181 6 29.926 24.7744 36.4585 -3.76808 18.8348 4.26027 -2182 4 30.4252 25.4661 35.9713 -7.21832 -13.6313 5.02454 -2183 4 29.9738 23.9763 35.9568 8.68635 -20.1437 -13.5665 -2184 6 8.66863 31.0429 3.90108 5.49181 -25.3701 -11.391 -2185 4 7.74616 30.7992 3.95988 -7.56137 -0.630176 -1.16432 -2186 4 8.75287 31.8877 4.30735 2.25384 31.6916 10.4967 -2187 6 5.52708 32.7014 11.4113 -17.1068 -29.6258 4.38787 -2188 4 4.72561 33.1583 11.715 12.8879 6.23598 -5.09299 -2189 4 5.16474 31.7796 11.3163 19.6841 23.1791 1.24929 -2190 6 45.6525 35.4522 20.4433 4.50188 -15.2767 -13.8779 -2191 4 45.1533 35.403 19.6071 0.884587 3.9764 11.125 -2192 4 46.1815 34.6145 20.4501 -8.61117 18.3435 2.22997 -2193 6 19.5135 2.78077 9.78076 -23.679 -24.2198 -16.6656 -2194 4 19.3296 3.70289 9.60293 -7.62346 7.89228 3.64078 -2195 4 18.7563 2.26696 9.35595 24.4568 20.2801 14.4664 -2196 6 54.9521 9.08257 10.915 1.41457 -13.8994 3.08946 -2197 4 54.8451 8.89609 11.8656 1.69601 3.75098 -5.72792 -2198 4 0.659909 9.73404 10.7859 1.63405 2.05096 5.26063 -2199 6 21.028 26.5613 14.7909 22.3934 -16.1712 -61.6784 -2200 4 21.2545 26.1082 13.8887 -5.63248 33.4215 43.8962 -2201 4 20.0757 26.5096 14.8457 -4.66041 -4.09977 8.40724 -2202 6 14.1565 30.5187 27.5481 43.0568 3.88252 13.2649 -2203 4 14.5478 30.2647 28.4319 -11.7888 3.54471 -30.6513 -2204 4 14.9443 30.8429 27.0102 -33.9181 -6.53128 14.6047 -2205 6 29.8147 17.3367 31.0866 -27.8518 -4.92818 12.2149 -2206 4 30.6554 17.4646 30.6741 20.9401 8.7355 -10.9161 -2207 4 29.248 18.1063 30.9142 12.1966 -0.59561 3.44929 -2208 6 50.8794 17.2985 27.8251 -38.7154 2.44379 -6.74856 -2209 4 49.927 17.6315 27.8951 41.9068 -8.6615 -2.42711 -2210 4 51.4551 17.8493 28.3603 -3.47276 2.02156 5.1771 -2211 6 46.2645 37.0852 13.9854 4.42941 -15.3994 -45.1385 -2212 4 46.1048 37.4162 14.8449 -7.65894 23.339 32.9902 -2213 4 45.682 37.569 13.3645 -0.578519 -6.08013 10.2779 -2214 6 38.1859 37.2676 33.1408 3.52211 -11.0724 24.5555 -2215 4 38.5393 37.4103 34.0404 -6.68303 -10.0954 -6.88307 -2216 4 38.6219 37.9461 32.6369 2.42637 17.4604 -15.0111 -2217 6 41.8357 13.3473 31.1178 -16.0625 23.8584 17.742 -2218 4 41.5851 13.9423 31.8754 7.82637 -22.3228 -20.2899 -2219 4 42.4009 12.6411 31.4368 6.59024 -10.1979 3.85371 -2220 6 46.9027 12.6459 17.8387 -27.1897 30.7666 -32.0186 -2221 4 46.619 13.5972 17.8049 11.7948 -22.8605 3.48595 -2222 4 46.5208 12.2901 16.9886 18.0608 -3.03081 22.7278 -2223 6 32.0582 10.0955 10.6527 -31.4378 50.3229 23.4622 -2224 4 31.7762 9.76632 11.5317 8.81554 -8.40176 -19.9459 -2225 4 31.6698 11.0464 10.7004 29.7372 -48.0302 -12.3835 -2226 6 34.0062 11.3773 6.75186 17.7871 30.589 25.6979 -2227 4 33.4869 10.5999 6.69262 -19.6684 -30.9606 -3.70709 -2228 4 33.8274 11.7035 7.66069 0.227829 -0.558148 -16.2574 -2229 6 45.3288 30.8634 19.4834 2.25993 -0.395596 -7.26595 -2230 4 45.2654 30.706 20.4282 2.85912 -9.1252 8.63447 -2231 4 45.808 30.1003 19.1195 -1.86475 4.39364 7.74954 -2232 6 20.3535 0.575918 7.15275 2.53913 19.7072 2.1264 -2233 4 20.3036 0.62077 8.11765 -6.02971 -5.31178 -3.74759 -2234 4 20.3373 41.5708 6.90351 -3.42232 -20.4047 0.354773 -2235 6 15.9901 39.4523 4.14302 -22.6863 14.3541 -4.96379 -2236 4 15.4898 39.956 3.48033 13.9059 -6.08345 -3.0001 -2237 4 15.6535 39.8695 4.95456 5.06581 -11.7067 3.21286 -2238 6 52.4222 16.4823 25.1021 7.38571 -14.026 0.748627 -2239 4 51.9391 16.8928 25.8315 -3.23714 5.96419 -6.435 -2240 4 52.4547 17.0876 24.3371 -9.72126 -3.91711 12.1205 -2241 6 38.5305 12.9945 3.24722 36.6577 77.8042 9.91619 -2242 4 38.7269 13.7231 3.96388 -16.2716 -45.5952 -32.5571 -2243 4 38.0745 12.2732 3.61889 -23.0516 -27.5087 18.4748 -2244 6 35.1404 29.6968 31.1683 -32.7778 -10.63 75.6098 -2245 4 35.326 30.1595 30.3922 19.5999 28.8984 -42.5223 -2246 4 34.769 30.3505 31.8393 8.36493 -22.8372 -28.4638 -2247 6 9.52941 33.7628 4.86075 -28.4918 10.8311 18.4951 -2248 4 9.24769 34.3211 5.62607 6.24621 -9.23174 -22.6788 -2249 4 10.3628 33.3905 5.10095 17.2263 -8.07265 -0.549435 -2250 6 21.5384 22.0668 20.5377 -8.24916 -13.7408 18.0665 -2251 4 20.8389 22.6833 20.2982 1.69112 5.82217 1.92954 -2252 4 21.3229 21.7148 21.445 5.44386 11.4228 -26.5573 -2253 6 37.5752 11.1922 41.2961 -25.7405 -15.8592 15.4541 -2254 4 38.0284 11.8044 40.7564 10.4246 30.4728 -30.151 -2255 4 38.2644 10.586 41.5433 15.0535 -11.8566 15.4014 -2256 6 33.8981 1.42806 38.7459 -9.94409 -6.93964 -8.18458 -2257 4 33.592 0.608166 38.3248 2.39341 2.703 9.2739 -2258 4 33.9534 1.28552 39.7002 -3.4763 3.29487 -4.45631 -2259 6 4.57081 26.6822 28.0049 6.08842 -57.033 -35.5124 -2260 4 5.0914 25.8197 28.0746 -15.9746 40.4578 4.78317 -2261 4 4.85783 27.3427 28.6052 16.6445 16.915 24.1865 -2262 6 10.2586 0.903759 11.6235 -14.777 -30.5961 35.2813 -2263 4 10.598 1.12099 12.5147 -1.53351 -1.03605 -18.7158 -2264 4 10.5217 1.55247 11.0069 12.731 34.1315 -22.4253 -2265 6 17.6428 19.8087 2.34625 28.3489 11.7442 10.4095 -2266 4 17.8694 20.4455 1.65312 -0.920106 -2.92675 2.15413 -2267 4 18.5186 19.4679 2.66241 -18.7748 -2.39069 -7.57655 -2268 6 32.4269 25.6656 16.4745 -22.7384 46.4686 12.005 -2269 4 32.9526 26.0936 17.1754 -0.693509 -13.2017 -11.5041 -2270 4 32.8268 24.9018 16.1119 18.5502 -33.1172 -3.66835 -2271 6 33.2526 10.6326 0.323883 9.44704 -29.8166 -9.67306 -2272 4 32.8511 9.97264 41.5994 12.5609 21.6724 15.7642 -2273 4 34.1113 10.2426 0.662313 -26.6835 12.0422 -7.05376 -2274 6 4.94395 4.51414 10.1428 13.8645 5.4827 29.102 -2275 4 4.09398 4.95549 10.181 -4.94694 -3.34603 -2.54834 -2276 4 5.29018 4.56097 11.0773 -8.61071 -3.77852 -28.7481 -2277 6 27.0981 16.9726 9.55361 -31.982 10.5528 -14.2027 -2278 4 27.1645 17.5497 10.32 4.78099 0.707575 6.97209 -2279 4 26.2221 17.2303 9.15822 25.9284 -7.90001 11.4222 -2280 6 9.97547 10.5192 19.3751 2.18725 8.20489 55.882 -2281 4 10.4385 9.92127 18.8097 14.3325 -20.7925 -15.5795 -2282 4 10.1136 10.195 20.3283 -2.00877 10.2565 -41.5362 -2283 6 19.5726 8.5313 27.8509 32.1681 -5.32712 19.6321 -2284 4 20.0623 8.73326 28.6965 -13.9453 -3.32017 -28.6613 -2285 4 20.1531 7.88958 27.3718 -16.7413 15.1406 10.2365 -2286 6 47.0715 38.9553 23.1297 -19.9487 1.16408 5.20576 -2287 4 47.6755 38.9992 22.3956 6.55525 -5.77104 -8.99339 -2288 4 46.1921 38.7934 22.7438 5.29072 4.97192 1.21114 -2289 6 19.6864 25.3648 11.2698 -35.9279 -4.62509 3.50742 -2290 4 18.9891 24.6498 11.3772 26.0807 25.4649 -7.71219 -2291 4 19.2193 26.1995 11.535 7.74761 -20.7647 -6.77192 -2292 6 27.3916 13.4622 15.7395 34.9583 -25.2468 -27.4167 -2293 4 26.6227 13.8144 16.1317 -23.8298 14.7279 29.1585 -2294 4 28.0863 13.1847 16.3728 -7.05347 8.15442 -0.924368 -2295 6 18.6718 14.1326 1.43279 -0.407031 -28.5308 -28.57 -2296 4 18.3771 15.0354 1.29678 -0.169849 11.7565 -8.38297 -2297 4 19.1904 13.8513 0.615983 -22.2167 19.1803 27.2908 -2298 6 42.3082 22.0346 32.4819 -45.1257 5.10199 -13.868 -2299 4 42.1064 21.5657 33.301 1.02444 -1.81924 7.74271 -2300 4 41.4227 22.4584 32.2639 35.231 -14.359 4.36271 -2301 6 10.0299 9.44853 2.50633 35.8335 -20.1603 -5.5533 -2302 4 9.22808 9.80314 2.87263 -22.9312 8.40439 12.9687 -2303 4 10.3707 8.71125 3.07205 -18.436 14.324 -8.13067 -2304 6 6.82989 1.45163 22.0085 -48.1074 -31.7833 -34.6048 -2305 4 5.93364 1.52189 21.5813 27.761 13.2569 19.2226 -2306 4 6.99793 0.508973 21.801 12.0554 14.7409 9.93393 -2307 6 11.2802 27.0298 18.9733 1.62982 48.8223 -5.8971 -2308 4 11.8533 27.1031 19.7597 -5.53045 -6.49976 -4.21856 -2309 4 11.2066 27.9871 18.6476 2.337 -33.8373 14.078 -2310 6 41.4807 20.5084 27.2133 -10.1157 30.3313 5.28758 -2311 4 41.6238 21.1535 27.9303 0.1153 -0.646751 -15.7402 -2312 4 41.3475 19.7242 27.7174 2.20222 -28.2193 4.24429 -2313 6 15.4457 24.115 33.4309 -8.0908 -15.9975 4.96928 -2314 4 14.6694 24.1264 34.0087 5.2648 16.329 -3.20307 -2315 4 15.6051 23.1634 33.3621 10.6851 2.75783 3.25666 -2316 6 36.1374 16.3773 10.0083 -2.95201 1.72364 21.0093 -2317 4 36.0354 15.4723 9.6971 0.275369 -1.57281 -6.84486 -2318 4 36.1532 16.3058 10.9756 2.3103 1.89663 -9.38056 -2319 6 51.7249 16.2592 2.09899 -0.8354 -35.479 4.00209 -2320 4 51.3025 16.6477 2.84061 -15.4293 29.383 24.1936 -2321 4 51.7588 15.3279 2.40044 5.70816 13.7616 -13.313 -2322 6 23.409 8.55726 39.7719 39.5062 -11.15 -25.6965 -2323 4 23.7264 8.82822 38.8637 -18.295 -2.70527 32.3134 -2324 4 24.154 8.00621 40.1033 -17.8621 14.2471 -2.43096 -2325 6 36.7611 34.4487 21.1056 -9.59584 -7.71653 -9.58874 -2326 4 37.1943 34.5847 20.2534 -2.45984 1.11901 0.357954 -2327 4 35.8017 34.351 20.9183 13.0848 5.20904 4.89404 -2328 6 14.146 8.88688 27.2949 11.3522 43.6232 -16.453 -2329 4 13.5534 8.17113 27.3093 -27.716 -37.4722 8.68734 -2330 4 15.0033 8.5993 27.5988 11.0136 -4.6565 4.44913 -2331 6 20.6652 37.4903 25.1946 -10.211 -17.9881 -36.0994 -2332 4 20.7454 36.6557 24.6643 4.11278 14.2078 23.4923 -2333 4 20.5382 38.1243 24.4693 3.50396 4.35638 18.4557 -2334 6 28.825 24.4792 30.0383 -7.87557 -12.5525 -14.3175 -2335 4 28.2203 24.3409 29.2957 -5.62902 14.2643 8.72595 -2336 4 29.6177 24.0933 29.6588 14.1928 -3.34691 9.72359 -2337 6 8.38024 12.0023 23.6849 17.6034 -17.8042 43.8798 -2338 4 9.33151 12.0391 24.0095 -25.5352 0.9508 -22.7134 -2339 4 7.93543 11.4413 24.3789 8.15752 13.9726 -18.9857 -2340 6 16.0957 26.6613 22.9482 -4.23776 -4.88874 3.00129 -2341 4 16.4041 25.8866 22.4682 2.11349 3.20317 -0.347462 -2342 4 15.2797 26.4088 23.4009 6.04671 4.79823 1.078 -2343 6 22.346 41.3881 9.48723 24.9275 -16.664 -2.62618 -2344 4 22.5706 0.299269 9.06271 5.87112 18.1013 -4.15908 -2345 4 21.5005 41.5154 9.87839 -30.5435 3.49176 4.55444 -2346 6 49.3776 19.1851 32.3736 41.1751 -38.6142 12.6649 -2347 4 49.9515 18.5305 32.8666 -19.8114 22.1793 -24.5398 -2348 4 48.9751 19.6643 33.0815 -18.7203 16.5505 12.5326 -2349 6 29.672 28.434 31.2292 -0.0990093 -59.7528 33.1636 -2350 4 30.5672 28.114 31.0525 8.33151 24.242 -15.2883 -2351 4 29.4026 27.6233 31.7702 -3.76231 36.9508 -17.5145 -2352 6 5.09757 39.1181 23.5694 28.9365 -16.8561 66.257 -2353 4 5.426 38.785 24.4883 -20.96 9.44698 -53.4069 -2354 4 5.17377 40.064 23.6953 -4.19226 13.7611 -6.16678 -2355 6 42.9396 13.594 41.6013 33.1291 -45.1938 12.1175 -2356 4 42.8466 14.3322 41.0449 -16.6361 37.6348 -21.2948 -2357 4 42.1546 13.3797 0.17078 -22.3633 5.8076 7.08965 -2358 6 21.2201 12.4318 7.37385 41.5974 -14.6934 -10.3279 -2359 4 20.2896 12.3563 7.35505 -36.2241 5.92132 -7.85999 -2360 4 21.5284 11.6004 6.96932 1.7608 11.2928 4.8084 -2361 6 43.1404 26.8989 37.6922 38.0431 -66.5876 34.8581 -2362 4 42.455 26.3454 37.3085 -15.3628 11.0452 -11.3741 -2363 4 43.7284 26.1839 38.1775 -25.099 52.0029 -25.4853 -2364 6 19.5406 10.6485 41.687 -7.00401 -34.9019 -10.1363 -2365 4 19.0738 10.6767 0.596923 -7.19888 -1.38148 21.2635 -2366 4 19.8536 11.5162 41.559 12.2515 43.5875 -9.13673 -2367 6 53.6223 10.061 3.2559 12.5469 7.56169 -12.6981 -2368 4 54.2024 10.8465 3.22155 -5.5124 -7.95383 7.8004 -2369 4 54.0687 9.40413 2.68363 -10.8512 12.6529 5.34221 -2370 6 17.5742 20.1926 28.4231 -27.2496 23.4973 23.4861 -2371 4 18.0413 19.6307 27.8376 17.787 -14.8025 -21.0857 -2372 4 18.1273 20.2938 29.2048 3.54631 -0.489564 0.0042962 -2373 6 36.884 7.32584 1.68504 -56.6071 21.2656 -14.3658 -2374 4 37.7051 7.59774 2.01592 38.2946 9.18211 20.2394 -2375 4 36.4748 8.1931 1.44071 3.42518 -20.8507 2.42249 -2376 6 29.2181 41.4159 1.83346 -7.01124 13.363 14.2223 -2377 4 28.4272 0.01466 2.15652 15.3791 -9.50345 -13.4545 -2378 4 29.1899 41.2946 0.880744 -4.61983 7.49126 -6.31737 -2379 6 13.5157 3.09172 8.12958 -12.3356 7.91728 -16.4605 -2380 4 12.824 3.78046 8.01164 12.4629 -9.10221 7.3254 -2381 4 13.8551 3.1491 9.02604 -1.1531 -1.24526 3.73064 -2382 6 15.0243 29.578 18.5071 -0.689822 5.1468 -1.91807 -2383 4 14.6889 28.924 17.8685 -1.8514 4.35612 11.642 -2384 4 14.2858 30.1508 18.7969 8.46412 -5.78667 -10.3485 -2385 6 10.5031 24.7013 24.3729 39.9308 52.3958 -21.489 -2386 4 10.8696 24.6855 23.439 -22.6214 -1.85919 30.3756 -2387 4 10.1444 23.8694 24.566 -23.1097 -44.7323 0.689524 -2388 6 2.33043 13.8499 25.1512 12.2217 -8.49201 10.1592 -2389 4 1.51988 13.5482 24.7402 -5.80441 -9.83551 -11.7005 -2390 4 2.2572 14.7938 25.1495 -10.3249 16.8303 -2.61333 -2391 6 31.8608 32.7615 29.8175 -5.917 1.92483 -13.0568 -2392 4 30.9148 32.9142 29.9093 1.86919 3.45723 4.06263 -2393 4 31.9038 31.8703 29.4643 1.33296 -6.10517 -4.90202 -2394 6 37.5413 40.8309 33.9785 -53.8639 -49.1526 -10.38 -2395 4 37.2515 40.0243 34.5353 23.0474 40.5808 -8.35317 -2396 4 36.818 40.8104 33.2846 24.4839 11.2763 19.2644 -2397 6 24.0486 38.1463 34.3459 4.38709 -25.8386 -29.9356 -2398 4 24.1932 38.0251 35.2675 1.20986 12.6476 31.9448 -2399 4 24.4562 37.3431 33.9843 -4.45208 9.66559 -5.62065 -2400 6 37.1813 22.5726 7.37313 12.7367 -26.0408 21.8779 -2401 4 37.6868 21.7363 7.50199 -14.9443 17.386 1.08188 -2402 4 37.2974 22.7741 6.46124 2.1827 3.60906 -24.8808 -2403 6 4.31908 23.2435 35.594 -25.7168 -2.52913 6.61784 -2404 4 4.31865 22.3787 35.1609 -1.33991 4.89576 -0.266123 -2405 4 3.37757 23.4898 35.7698 13.7393 -2.9658 -3.46645 -2406 6 15.7444 14.893 2.66063 14.3192 36.2435 46.5189 -2407 4 15.9445 15.8567 2.71494 4.00237 -25.0016 7.78932 -2408 4 15.3014 14.8369 1.84861 -12.1852 -13.1154 -36.1328 -2409 6 48.1607 23.1823 2.03014 17.998 -4.54201 -11.9107 -2410 4 48.5744 23.458 2.84259 8.43731 2.94545 12.5813 -2411 4 48.9225 22.9045 1.46682 -22.9697 5.41467 1.46601 -2412 6 24.1212 19.9771 21.5555 -13.5297 -6.85262 15.9953 -2413 4 24.2241 19.3198 22.2577 -12.7792 13.8262 1.69378 -2414 4 24.7627 19.6352 20.9706 23.452 2.79195 -33.2435 -2415 6 10.5793 29.3754 5.15175 -1.75103 26.9922 -14.4666 -2416 4 9.93004 29.8841 4.64694 -13.9608 -12.0643 5.47156 -2417 4 11.3599 29.8389 4.86113 16.4531 -5.21099 6.28998 -2418 6 5.96767 27.6933 31.2336 10.2296 -18.0279 -26.5205 -2419 4 6.63185 27.1353 30.7398 -17.0624 11.0978 13.8341 -2420 4 6.49058 28.2721 31.7915 6.44996 0.578865 12.7715 -2421 6 18.5397 25.8071 15.3312 30.8629 -17.2743 -78.9847 -2422 4 18.3277 25.7099 16.2038 -28.7942 6.39581 79.7195 -2423 4 17.897 26.3418 14.8644 -17.4943 11.9017 11.8989 -2424 6 52.0949 37.2335 11.1138 -0.736115 -25.1617 0.200807 -2425 4 52.5552 36.4743 10.7101 2.49656 11.0988 9.7325 -2426 4 52.7586 37.8745 11.3958 -2.29245 7.10647 -7.85035 -2427 6 46.8562 14.6296 7.3094 -39.0502 -6.9365 63.794 -2428 4 46.1382 15.0906 7.8718 34.2719 -4.68193 -40.7336 -2429 4 47.0431 13.9061 7.9424 14.2062 7.46383 -20.3992 -2430 6 22.2508 0.698906 41.6783 16.129 -5.34947 -25.8041 -2431 4 22.2008 1.66415 41.7125 4.72421 -6.65403 -6.59212 -2432 4 22.9559 0.389699 41.0229 -20.0941 20.4891 31.5318 -2433 6 4.05761 14.7345 9.27152 -10.7438 13.6286 -6.0443 -2434 4 3.56043 15.5915 9.15395 12.8436 -23.8424 -1.56379 -2435 4 4.93811 14.8828 8.92118 3.87558 5.66633 -1.10852 -2436 6 37.2917 12.6666 37.0157 -30.741 -16.0859 47.3668 -2437 4 37.7371 12.676 37.8973 0.89189 9.6387 -16.8975 -2438 4 36.3707 12.3712 37.2872 32.4569 8.65188 -22.8431 -2439 6 26.6682 29.0903 40.5985 -18.9168 16.4285 3.4146 -2440 4 27.032 28.2632 40.812 19.8197 -36.7417 16.2821 -2441 4 26.6469 29.0593 39.6552 2.37875 14.8387 -20.8034 -2442 6 7.22455 13.851 3.31845 32.6668 -55.3021 -17.7697 -2443 4 8.0198 14.2759 3.60088 8.05656 35.1068 9.02454 -2444 4 7.66854 12.9807 3.04146 -45.3946 28.1811 11.8363 -2445 6 8.95271 34.8627 28.8342 33.802 -52.1542 -15.9648 -2446 4 9.89817 35.0055 28.6074 -18.5208 0.484683 7.95646 -2447 4 8.56267 35.6958 28.9173 -17.8026 46.8286 13.0667 -2448 6 37.1756 40.0691 40.1061 46.0034 7.56439 6.60252 -2449 4 36.245 40.1688 40.0074 -20.2243 -4.13511 -1.70673 -2450 4 37.2907 39.5142 40.8911 -6.64471 -1.97244 -3.69085 -2451 6 30.3689 6.165 27.2364 16.9392 12.8422 63.3115 -2452 4 30.1126 5.75506 28.1249 0.00544273 9.78172 -37.0876 -2453 4 31.0397 6.83064 27.5702 -18.6179 -11.6186 -23.6342 -2454 6 10.4791 22.885 18.2972 2.22892 -25.7937 -34.5052 -2455 4 11.3494 23.0331 18.653 10.7715 4.73748 7.10061 -2456 4 10.6446 22.3032 17.5049 -10.188 21.0769 23.5682 -2457 6 35.8886 14.2524 40.1239 38.6938 29.9036 -1.43051 -2458 4 35.4161 14.6576 39.3846 -1.71718 -13.5804 13.4977 -2459 4 35.4021 13.6019 40.5864 -31.0402 -18.1501 6.5583 -2460 6 6.71723 1.08854 17.7001 -3.83901 -60.8198 25.71 -2461 4 6.23156 1.19942 18.5167 -3.21909 18.7445 0.671973 -2462 4 6.88149 0.099135 17.7878 0.895752 34.2898 -15.7018 -2463 6 41.3468 34.0461 33.1794 10.5682 19.0983 -18.7578 -2464 4 40.4721 34.2712 32.8864 -29.2649 -1.70533 3.43004 -2465 4 41.8357 34.5632 32.5195 11.425 -3.18121 9.05585 -2466 6 37.2595 0.990816 41.287 9.45411 17.3584 -9.40071 -2467 4 37.687 0.20533 40.9743 -1.4253 -22.058 -8.3634 -2468 4 37.4586 1.01742 0.30817 4.28067 1.92511 18.4856 -2469 6 25.2602 30.9527 6.20609 -41.9214 10.7977 -12.9978 -2470 4 25.877 31.4326 5.6764 28.9604 0.775163 -4.96937 -2471 4 24.4759 30.9469 5.60333 12.4846 -9.23957 25.2824 -2472 6 14.2056 24.502 28.3086 -25.5247 14.5131 -24.5719 -2473 4 14.1882 23.6623 28.7056 13.4522 -31.4953 30.087 -2474 4 13.7133 24.2842 27.5041 7.94148 19.2098 -3.82225 -2475 6 34.2051 26.2238 36.0112 -48.9031 41.3361 24.9979 -2476 4 35.1144 26.3624 36.1822 32.7561 -2.50775 4.45543 -2477 4 33.7446 26.9807 36.5344 19.2218 -36.9328 -23.3608 -2478 6 32.3568 8.33098 28 25.7802 40.2385 3.20277 -2479 4 32.7565 9.24505 28.063 -37.9579 -17.4528 3.85033 -2480 4 33.1461 7.94224 27.6538 8.5967 -27.8742 -9.28785 -2481 6 11.7867 0.286536 26.9724 -1.3913 -35.2382 4.72224 -2482 4 11.7865 41.2385 26.6946 0.846362 23.7064 4.93964 -2483 4 11.6054 0.272418 27.9282 2.03777 4.09428 -12.4872 -2484 6 1.68124 0.254113 10.3309 8.7986 -13.2184 -15.0921 -2485 4 1.59717 41.2916 10.7333 -0.0350141 -2.89412 -0.990995 -2486 4 1.41389 0.849687 11.0071 -7.7361 15.4014 20.6266 -2487 6 6.75173 13.8377 8.23874 -3.6693 30.6435 -30.4665 -2488 4 6.43924 13.9799 7.29904 9.51956 -14.6006 30.1073 -2489 4 7.1653 14.6974 8.43116 5.95594 -9.45057 4.81521 -2490 6 22.2348 20.5564 6.16471 -24.0844 -9.72934 13.195 -2491 4 21.6727 21.3518 6.25881 9.87637 -7.56006 0.262552 -2492 4 21.7029 19.8181 6.55593 11.5262 14.9976 -6.6436 -2493 6 17.385 20.4497 10.8769 -35.9329 27.9153 -37.8305 -2494 4 16.5515 20.156 10.4074 25.3596 -4.97581 21.0147 -2495 4 17.441 21.3848 10.5386 11.6957 -25.2138 21.3318 -2496 6 17.7006 4.52737 19.573 -11.3777 -34.9061 -6.08889 -2497 4 17.032 4.43128 20.2569 -5.49224 11.1956 3.68583 -2498 4 17.4813 3.72403 19.0236 15.4315 33.5846 4.92098 -2499 6 0.483339 18.1114 40.0861 11.4726 -7.5634 -25.4826 -2500 4 0.218803 18.6551 40.8031 -6.40406 19.3 17.6992 -2501 4 1.29471 18.4968 39.6981 -7.50073 -9.94226 4.45973 -2502 6 22.9439 24.8131 27.8304 -1.07592 37.7895 -56.3844 -2503 4 22.8309 25.5845 27.1671 -0.125595 -37.7338 24.1587 -2504 4 22.7938 25.2149 28.6606 -3.1997 14.6603 34.334 -2505 6 42.7926 39.1547 26.7662 4.75434 20.2168 6.00074 -2506 4 43.0175 38.5002 26.1242 -2.01943 -24.6309 -11.9253 -2507 4 43.3024 39.9142 26.4608 -1.73796 0.515913 11.2644 -2508 6 26.2338 3.05974 21.8008 -0.713756 21.3652 -6.58596 -2509 4 25.6341 3.75271 22.1513 17.432 -13.3686 -8.49125 -2510 4 26.841 3.50549 21.1637 -15.4189 -7.95734 10.2455 -2511 6 54.5913 9.88629 29.5891 14.6194 -0.200122 15.6168 -2512 4 54.0185 9.11016 29.6389 -2.18077 1.53735 0.0476299 -2513 4 54.8498 10.0557 30.5251 -12.748 -2.88746 -21.9109 -2514 6 24.7662 33.7505 20.5324 -4.4887 -11.5901 7.32024 -2515 4 24.6764 34.6709 20.8407 -1.82029 -5.26135 -2.53883 -2516 4 23.9322 33.4503 20.1388 -0.463927 12.2923 -3.35723 -2517 6 41.7034 16.3049 0.90063 -4.83399 22.4927 -47.1255 -2518 4 41.2734 15.9533 1.64089 -16.394 -13.425 40.883 -2519 4 42.6233 16.3659 1.12415 18.2298 -9.67465 4.77205 -2520 6 23.3998 27.9207 27.4832 -10.7606 37.0497 -28.3533 -2521 4 22.8282 28.3407 28.1441 5.00816 -9.79407 0.156118 -2522 4 23.2556 28.495 26.6632 8.58882 -24.5485 28.392 -2523 6 32.7859 37.2984 18.7364 25.7014 -40.2058 6.96479 -2524 4 33.7401 36.9719 18.7703 -32.5146 22.7172 4.70252 -2525 4 32.7784 38.1932 18.4283 6.4981 19.1078 -10.0488 -2526 6 21.2249 27.6889 4.78917 1.7584 -25.2435 -20.8654 -2527 4 20.596 27.4146 5.46499 -5.42949 1.48454 -4.75098 -2528 4 21.0369 27.1287 3.96943 -0.427807 22.4392 26.4825 -2529 6 54.9457 17.9605 1.83049 24.1732 12.1415 15.992 -2530 4 54.6765 17.1472 1.44643 -11.2843 -21.2768 -12.0273 -2531 4 54.1938 18.5428 1.86671 -18.1074 1.0363 -7.50679 -2532 6 36.7435 10.702 6.59289 -49.1612 2.30359 2.88264 -2533 4 35.7736 10.9925 6.66913 36.3355 -9.83622 -8.29906 -2534 4 36.7226 9.77144 6.87602 6.19961 4.27664 0.325158 -2535 6 54.2959 4.49421 14.021 -47.0247 26.1641 -8.2037 -2536 4 53.712 4.99768 13.3924 28.2438 -8.88077 8.93165 -2537 4 53.834 4.66365 14.8572 10.6634 -9.95324 4.36694 -2538 6 22.1071 12.8195 32.0067 31.7906 8.9597 -11.0311 -2539 4 21.2967 13.3066 31.9589 -27.922 0.108445 -0.906739 -2540 4 22.6887 13.2954 31.3728 -6.4895 -15.5456 16.1837 -2541 6 15.3021 36.6565 4.03444 -21.8215 23.8176 13.2077 -2542 4 15.3262 37.6185 3.88215 -1.10116 -7.72226 9.53853 -2543 4 16.0423 36.3695 3.52653 17.7184 -15.2462 -10.6327 -2544 6 23.951 1.27123 5.71091 12.3119 19.4094 13.4558 -2545 4 23.1735 0.716989 5.76524 -11.3354 -5.61231 -0.786433 -2546 4 24.0519 1.77027 6.55293 -6.00641 -12.6326 -15.7345 -2547 6 14.2792 12.648 15.8066 19.0644 9.13243 11.8341 -2548 4 14.5911 12.5731 14.893 -12.6174 -10.6299 -3.28453 -2549 4 13.3818 12.3002 15.9605 12.2346 2.97194 -15.7557 -2550 6 15.0388 40.2481 6.5891 -30.9219 -16.0267 -20.9978 -2551 4 15.8926 40.3583 6.97574 17.8619 16.6743 19.574 -2552 4 14.4622 41.0349 6.73493 18.0926 -11.8876 3.06612 -2553 6 48.5605 32.6308 12.0872 21.4935 -15.1737 -19.6402 -2554 4 48.2882 31.8163 11.6222 -11.7375 10.5522 8.8403 -2555 4 49.3772 32.8772 11.5869 -20.063 0.749688 13.0696 -2556 6 11.2909 31.5377 7.21713 -14.6129 -9.26005 -15.8818 -2557 4 10.6224 30.9548 6.78826 17.7824 9.96971 10.6082 -2558 4 11.6163 32.1134 6.50388 0.884245 -9.77636 6.63484 -2559 6 30.1231 27.9968 10.2226 9.10006 8.28679 -14.6513 -2560 4 30.718 28.7273 9.95045 -8.34799 -9.59518 10.9295 -2561 4 29.9727 27.4897 9.40845 -5.6962 -0.318113 1.27302 -2562 6 27.6759 22.1164 17.3809 2.93811 -8.1883 -22.8269 -2563 4 27.2909 21.5233 16.7142 1.55949 -2.9899 10.1125 -2564 4 28.0309 22.8242 16.8263 2.77593 4.45495 11.6125 -2565 6 12.9654 4.59514 18.1625 -0.934721 -11.3223 -0.518608 -2566 4 13.4589 3.798 18.4727 -12.2499 12.1104 -13.3514 -2567 4 12.4628 4.36939 17.3497 12.7979 1.84773 4.27522 -2568 6 19.7203 6.71654 19.0744 25.855 21.5282 16.2244 -2569 4 18.977 6.16103 19.2554 -18.9537 -21.446 -0.739234 -2570 4 20.1996 6.78409 19.9214 -9.72031 -0.922856 -11.6068 -2571 6 37.1527 31.3787 11.4669 20.5156 -3.08539 55.9419 -2572 4 36.5467 31.6235 12.1801 -19.4555 -0.126446 -17.2692 -2573 4 37.8531 31.0173 12.0578 -6.7166 -8.42047 -30.0342 -2574 6 3.11862 16.2015 27.3491 -14.8948 -19.7352 -9.46107 -2575 4 2.52427 15.4561 27.6487 20.3886 21.5408 -12.2486 -2576 4 3.15348 16.212 26.3649 -6.24389 -0.0501167 23.7097 -2577 6 15.7133 9.97724 38.3591 30.328 17.4212 13.8857 -2578 4 16.1258 10.8398 38.0549 -11.3336 -30.4403 16.2583 -2579 4 16.257 9.66317 39.1359 -16.0932 10.0631 -23.9552 -2580 6 13.4043 14.2884 8.2363 15.0986 25.1191 -5.83206 -2581 4 13.804 15.2225 8.33958 -5.13839 -47.7054 6.28407 -2582 4 14.0947 13.5837 8.31616 -11.6402 16.8216 1.41307 -2583 6 1.71524 24.3141 36.392 36.4901 -22.2748 31.9402 -2584 4 1.86474 25.1068 36.8985 9.35176 9.25273 5.49175 -2585 4 1.1215 24.6177 35.7571 -36.8309 10.6894 -41.0698 -2586 6 11.1862 26.5319 32.9688 15.239 -24.9993 36.2438 -2587 4 10.9649 26.8002 32.096 -11.5382 16.0703 -24.8314 -2588 4 11.1647 27.266 33.6054 -7.17864 1.89937 -11.754 -2589 6 29.5773 0.765668 36.2911 32.6527 8.9619 33.1448 -2590 4 29.1495 0.596705 35.4758 -23.483 -6.97315 -25.4485 -2591 4 28.9625 1.07408 36.9696 -5.35236 0.153158 -12.2969 -2592 6 43.6099 13.1071 23.908 -7.75428 16.7256 -33.2383 -2593 4 42.8302 13.3868 24.3919 -4.08537 -1.1131 9.93358 -2594 4 43.3622 13.2586 22.9511 7.4693 -9.27191 32.0602 -2595 6 7.44309 19.7767 19.6705 17.8438 12.6527 -6.23579 -2596 4 6.73015 19.1919 19.919 -3.61392 -10.9972 -0.189724 -2597 4 7.6227 19.7194 18.722 -11.1837 -0.704544 3.42764 -2598 6 24.4259 4.29913 7.83629 -8.5248 -0.10499 -3.36953 -2599 4 24.144 5.21077 7.98541 -0.150025 -7.47068 -3.31634 -2600 4 24.9904 4.0546 8.57206 4.90899 -0.271036 -1.18338 -2601 6 51.4883 30.2308 31.1674 -14.7545 1.56633 -0.747328 -2602 4 50.5925 29.8847 31.2768 -1.35209 3.55691 8.49804 -2603 4 51.5844 30.2463 30.2146 11.2248 2.3182 -11.9335 -2604 6 0.913373 23.6795 16.8764 44.9279 -35.4578 23.1065 -2605 4 0.053834 23.3329 16.7065 -24.7033 4.18361 -15.1926 -2606 4 1.39802 22.8443 17.1197 -4.68332 28.5423 -3.90241 -2607 6 45.0884 19.3939 15.6913 9.05154 29.148 -44.7311 -2608 4 45.9115 18.9543 15.4906 10.1171 -6.0821 0.331933 -2609 4 44.8041 18.9926 16.4702 -27.3917 -26.115 43.7395 -2610 6 17.5003 8.70625 40.5861 -20.5343 49.5779 -9.15489 -2611 4 18.1762 9.35755 40.8219 0.532033 0.318295 -4.52849 -2612 4 17.8864 7.89597 40.8225 20.4785 -39.0634 11.6529 -2613 6 30.1832 27.259 27.1983 -17.9859 30.5387 -1.70378 -2614 4 31.0843 27.5469 27.0174 5.19664 -5.65516 3.8328 -2615 4 29.6652 28.1124 27.2385 17.8651 -30.9588 0.0373123 -2616 6 43.0672 26.1987 28.3737 -1.21405 11.7795 -35.2128 -2617 4 43.2187 25.7399 27.5308 2.18298 5.51683 1.33219 -2618 4 43.1307 25.5038 29.0079 -1.74848 -11.3154 21.2466 -2619 6 27.987 7.5851 3.0601 9.13665 18.2748 23.7588 -2620 4 28.1896 6.93215 2.40721 -2.30749 -24.2619 -13.6918 -2621 4 28.5512 7.39371 3.84357 -9.52219 0.418204 -9.11945 -2622 6 44.6779 7.22362 10.1855 -3.82519 12.3682 29.7072 -2623 4 44.5846 7.37997 11.1613 -8.64186 4.71212 -23.3906 -2624 4 45.2067 6.43644 10.1815 9.68596 -14.557 -3.94398 -2625 6 23.537 20.3907 32.2607 -4.33975 0.880185 -5.57314 -2626 4 23.324 21.1985 32.7413 -3.519 5.94106 -1.71472 -2627 4 23.9311 19.8373 32.9365 5.99895 -7.24541 1.02787 -2628 6 37.5412 21.0533 29.2807 6.26587 16.0676 16.0196 -2629 4 37.3761 20.3248 28.6837 -16.0493 -11.7352 -10.5522 -2630 4 36.7218 21.4261 29.6708 7.43039 -8.09007 -9.52559 -2631 6 49.2859 29.0787 28.7031 8.16517 -18.5587 -1.11584 -2632 4 48.658 29.8007 28.598 1.09858 8.52384 -10.5349 -2633 4 50.1522 29.3365 28.3345 -7.12297 8.09394 6.40204 -2634 6 47.5144 18.1684 15.2382 -13.098 45.3115 -50.4885 -2635 4 48.063 17.6794 15.7982 26.613 -22.2712 34.0874 -2636 4 48.011 18.9832 14.9644 -13.0138 -21.3801 10.9042 -2637 6 23.2587 11.168 16.5961 -34.2623 -16.0228 11.9175 -2638 4 23.8181 11.8474 16.2701 22.3391 18.1069 -12.9732 -2639 4 23.6107 10.3074 16.3447 5.63526 2.71733 -4.05723 -2640 6 3.14661 8.32736 23.1966 -5.33081 14.6732 5.33529 -2641 4 3.33443 7.84562 22.3891 5.23826 -4.81966 -4.36628 -2642 4 3.62138 9.17513 23.1245 -2.82501 -4.35917 1.75332 -2643 6 0.508878 16.1819 6.17622 16.4304 7.97407 55.7173 -2644 4 1.47866 16.3831 6.12713 -25.5039 -9.61354 -6.44341 -2645 4 0.329178 16.1408 7.1857 2.48639 -0.0834422 -46.7437 -2646 6 43.1796 15.6993 5.84098 -15.9449 -20.1226 -10.4934 -2647 4 42.9586 16.4507 6.36104 0.864404 19.5468 17.3894 -2648 4 44.0486 15.8407 5.47017 17.9332 8.6581 -2.45416 -2649 6 16.7038 35.4743 34.4518 -23.198 12.4372 32.502 -2650 4 15.9504 35.0582 34.0028 7.47206 -3.63127 2.95791 -2651 4 16.3197 35.7905 35.3305 20.1374 -9.24319 -26.2799 -2652 6 38.8854 7.73874 15.6833 27.6202 35.8952 13.402 -2653 4 39.2486 7.07212 15.1014 0.737034 -8.76325 -8.48971 -2654 4 39.6641 8.33099 15.9666 -32.1226 -27.7665 -11.1551 -2655 6 42.0076 36.5182 13.641 -8.45099 16.164 -4.64077 -2656 4 41.9228 35.5752 13.5656 2.538 -16.9665 4.44933 -2657 4 41.1544 36.8356 13.3036 3.7559 4.14555 2.82714 -2658 6 54.2986 15.3848 32.1119 10.5246 -16.1102 10.831 -2659 4 0.035655 15.9755 32.3754 -8.42237 -3.15332 1.00609 -2660 4 53.5781 15.9253 31.7943 -3.3302 7.96061 -4.64421 -2661 6 22.8954 13.9973 39.0304 35.7671 -1.21675 7.49641 -2662 4 23.2761 14.8055 39.421 -4.93619 -7.73369 -6.00904 -2663 4 21.9819 14.1606 38.8837 -32.0989 6.28079 -4.51925 -2664 6 48.0426 28.53 4.78367 -18.7604 -12.0579 33.007 -2665 4 48.5209 28.7824 4.01456 21.1512 11.8238 -22.7946 -2666 4 47.6247 29.3288 5.14776 5.26678 3.3179 -1.38234 -2667 6 48.833 10.6059 2.66638 -9.19187 -9.9608 -41.9733 -2668 4 48.2371 10.184 3.25557 -19.2293 -15.3999 15.8868 -2669 4 49.4018 11.1117 3.19515 27.1663 25.8201 26.2609 -2670 6 17.1043 29.3494 4.41938 0.116954 -3.05469 4.91749 -2671 4 16.3442 28.823 4.73493 -1.75912 12.177 1.49975 -2672 4 17.4207 29.929 5.14153 -0.429925 -17.6765 -0.899977 -2673 6 27.7901 7.33424 26.577 58.6208 -10.7281 -9.65958 -2674 4 28.6921 6.89516 26.6033 -20.1634 35.8081 4.28732 -2675 4 27.2961 6.54785 26.6418 -36.3357 -24.7905 3.70209 -2676 6 18.0242 22.0537 22.5144 -27.9591 -16.1551 -40.0832 -2677 4 18.4878 21.2118 22.5153 10.7066 -2.42354 6.7168 -2678 4 17.4966 21.98 21.6478 21.0889 16.8172 36.9195 -2679 6 22.144 25.0979 16.6837 -22.767 31.6961 -6.75713 -2680 4 21.8754 25.6012 15.8609 3.46788 -12.1894 37.0641 -2681 4 22.4796 24.2953 16.3382 13.1119 -24.3628 -7.92486 -2682 6 25.5147 28.4379 7.13209 -32.2353 18.5879 42.0502 -2683 4 25.3191 28.6153 8.09624 16.8162 -18.2828 -29.7283 -2684 4 25.4949 29.3399 6.82105 5.5127 9.28731 -21.7507 -2685 6 42.5447 24.7469 23.7482 -26.0567 17.8354 -0.260974 -2686 4 41.659 25.0561 24.0862 27.8337 1.55541 -7.56443 -2687 4 42.5141 23.8045 23.8516 -5.7883 -22.6777 0.706816 -2688 6 6.24511 16.6188 2.47068 -21.6781 9.7655 5.77715 -2689 4 5.36273 16.9874 2.41541 -6.24724 13.8235 -1.18511 -2690 4 6.01398 15.7093 2.58331 16.9883 -26.009 1.35247 -2691 6 47.3719 33.28 1.46148 -3.99946 1.01934 -28.2481 -2692 4 46.9803 34.1218 1.66358 -4.59906 12.9067 -8.65937 -2693 4 47.69 33.0389 2.30921 14.6803 -12.3184 23.7614 -2694 6 1.27616 36.1851 24.8829 8.16993 1.58395 -5.27854 -2695 4 0.639753 36.4584 25.5359 -13.8461 11.829 3.50901 -2696 4 1.57271 35.3754 25.2942 10.46 -9.74103 -2.86729 -2697 6 20.9413 29.0442 16.4303 -37.0385 3.95749 11.2157 -2698 4 21.4069 28.5201 15.8013 19.747 -14.8546 -14.4583 -2699 4 21.4101 29.8248 16.6953 16.4704 9.62387 -0.234111 -2700 6 18.6701 32.5426 14.1399 -11.935 -28.2137 10.094 -2701 4 17.8036 32.9051 14.2078 -15.3524 29.2867 2.90472 -2702 4 18.4356 31.618 14.3552 23.1856 4.50503 -1.59621 -2703 6 15.7338 41.7002 0.007017 -29.1796 -38.8659 -6.04008 -2704 4 15.5134 41.1073 41.1476 16.5192 17.684 16.0218 -2705 4 15.1804 41.3134 0.738607 16.9589 18.7767 -12.0866 -2706 6 20.5358 18.4015 7.20723 -36.4209 10.7746 11.3165 -2707 4 20.1727 18.4996 8.12034 18.5895 1.11111 -8.73102 -2708 4 19.7156 18.4439 6.66948 20.5956 -6.66311 2.45516 -2709 6 35.3359 2.82506 1.61733 -4.03181 47.7257 29.2165 -2710 4 34.9541 3.20961 2.47337 19.1106 -23.159 -34.5889 -2711 4 35.8528 3.61912 1.28524 -9.69035 -30.1723 1.40188 -2712 6 49.0059 19.6751 24.9502 -26.306 10.305 -4.58994 -2713 4 49.8292 19.282 24.7191 18.9727 -16.8119 -2.00329 -2714 4 49.219 20.61 24.9195 -6.54834 1.96917 8.98321 -2715 6 26.0427 7.1974 41.5664 19.1127 -25.9459 -27.3591 -2716 4 26.6886 6.46136 41.6822 -6.92827 19.3426 1.38611 -2717 4 25.5576 7.23966 0.456505 -11.7101 6.8047 33.8929 -2718 6 22.0248 3.60461 29.0185 -16.0846 7.25678 -9.40108 -2719 4 21.194 3.80897 28.5456 14.569 -4.87522 0.502932 -2720 4 22.1959 4.40114 29.525 4.81678 0.210141 7.58007 -2721 6 27.8548 32.5394 20.644 30.2008 -27.0251 30.2495 -2722 4 26.9598 32.7332 20.4747 -36.3343 12.7784 -11.814 -2723 4 28.412 33.1097 20.1287 0.615935 11.6015 -11.5439 -2724 6 8.3956 24.7909 3.45677 41.8783 30.6212 2.1827 -2725 4 8.85983 24.2427 2.83372 10.4085 -11.4169 -11.9204 -2726 4 7.65564 24.3184 3.74512 -41.6031 -24.257 6.19876 -2727 6 30.5856 41.7288 15.6573 18.8319 11.6475 40.5199 -2728 4 29.9513 0.161741 16.3149 8.82373 -8.1621 -4.69308 -2729 4 30.0935 41.6309 14.8822 -24.2072 -8.84927 -42.274 -2730 6 48.0984 5.63232 21.2085 -24.8678 -8.67647 -10.7387 -2731 4 47.6235 6.28714 20.6867 8.63769 7.09972 -0.446275 -2732 4 47.3595 5.05066 21.4474 12.3779 0.983941 9.20385 -2733 6 39.4236 23.163 35.7324 -26.6807 -22.8308 -31.4054 -2734 4 39.8477 23.6904 36.3502 31.9199 30.6139 46.0523 -2735 4 38.8623 22.5516 36.2186 -1.29306 -3.58423 7.04543 -2736 6 51.5883 33.3617 5.78995 -19.5798 -55.0773 -18.3228 -2737 4 51.7861 34.2574 5.89467 9.96767 53.6603 7.25336 -2738 4 51.5145 33.1869 4.82901 1.99858 6.27826 11.2132 -2739 6 40.1205 17.6413 30.7797 3.51386 -32.8888 9.0941 -2740 4 39.6335 18.3955 31.0853 6.47279 10.0891 -2.42254 -2741 4 40.8254 17.9321 30.1952 -5.08805 1.72673 -6.80625 -2742 6 46.4235 9.81086 18.5807 -13.6096 13.2326 25.0066 -2743 4 47.164 10.4099 18.4597 3.17276 -2.49269 -0.272695 -2744 4 46.3941 9.2422 17.832 2.02048 -17.819 -25.0993 -2745 6 15.8844 41.0843 31.9336 24.9021 -3.26155 -16.7898 -2746 4 16.5805 40.7078 31.3592 -9.31569 -10.1627 6.74042 -2747 4 16.1791 0.090931 31.8861 -11.051 9.97246 9.22539 -2748 6 48.5496 25.7276 14.9325 -23.4699 4.48431 -20.1118 -2749 4 49.4421 25.9075 14.7294 36.7388 1.67727 3.80263 -2750 4 48.1707 25.827 14.039 -11.0362 0.596064 15.3478 -2751 6 39.2225 28.9892 36.1575 1.81804 -9.3363 -11.5399 -2752 4 40.0459 29.1043 36.6225 6.32097 13.8964 11.0865 -2753 4 39.5169 28.7877 35.2623 -5.25992 -5.15898 -10.721 -2754 6 37.325 21.0738 14.9394 -7.85324 -20.9229 -64.7065 -2755 4 37.9996 20.7799 14.2865 -1.58038 10.9233 26.036 -2756 4 36.5898 21.2349 14.28 11.1979 5.88457 46.2171 -2757 6 32.4971 22.8607 15.7433 -7.91212 -33.4559 24.7905 -2758 4 31.7632 22.4534 15.25 1.55934 10.0805 -2.32687 -2759 4 32.5592 22.2921 16.5663 4.31702 21.463 -27.4441 -2760 6 18.5773 8.13014 37.5708 2.8796 34.5567 21.0854 -2761 4 19.1021 8.93687 37.8089 1.20854 -19.8484 -10.1251 -2762 4 17.9431 8.09722 38.288 -3.97249 -3.14491 3.87795 -2763 6 46.9308 30.3817 11.0144 7.20248 -9.32119 -46.6603 -2764 4 46.4987 30.7035 10.1833 6.25688 -3.94108 30.979 -2765 4 47.431 29.6318 10.6212 -6.26387 6.19468 23.2459 -2766 6 54.6355 13.051 30.6677 -0.631529 -12.3617 0.377161 -2767 4 54.9401 12.1973 31.0202 -4.70537 6.73717 3.83911 -2768 4 54.6706 13.679 31.4001 -0.542159 7.57402 -2.77471 -2769 6 32.2973 35.1412 27.9506 0.702746 7.41177 51.9011 -2770 4 32.3519 35.6753 28.7977 -4.11304 1.55554 -34.3644 -2771 4 32.0809 34.2722 28.2835 1.42742 -15.3938 2.35714 -2772 6 4.45353 25.396 31.7914 -28.2716 -32.1048 1.32297 -2773 4 5.00928 24.905 32.4172 3.79617 9.45861 3.32159 -2774 4 4.83781 26.2295 31.6234 26.2458 34.1175 0.407684 -2775 6 40.7781 38.1509 21.8521 -13.1408 -33.509 11.5706 -2776 4 40.6716 39.044 22.1698 7.33695 21.0707 -1.24628 -2777 4 41.4481 38.0623 21.1738 10.5508 14.8215 -9.14642 -2778 6 26.6931 9.85845 27.4042 -43.8759 24.145 24.882 -2779 4 26.9952 9.1619 26.8761 23.7363 -35.7414 -23.7206 -2780 4 25.7673 9.60487 27.6152 14.5566 8.07269 5.62533 -2781 6 53.3967 39.4485 11.7649 68.843 -10.0355 -14.0333 -2782 4 54.4148 39.3855 11.5456 -53.2103 8.20916 12.7106 -2783 4 53.105 40.2482 11.2866 -1.29569 -7.05369 14.3337 -2784 6 35.3292 21.4155 2.23587 15.106 -7.83484 -18.4876 -2785 4 34.912 20.5764 2.48744 -1.27765 6.93695 -0.309601 -2786 4 35.8084 21.2289 1.37944 -21.1629 3.53466 26.6292 -2787 6 4.14409 17.1449 33.9131 -16.1644 -22.9901 22.0601 -2788 4 4.14131 16.4411 34.6063 8.69636 10.7601 -14.4963 -2789 4 3.20404 17.192 33.6728 6.06844 1.20479 -9.99864 -2790 6 24.1486 16.1886 14.6752 2.90394 -28.6462 -21.9437 -2791 4 24.2343 17.059 15.0346 0.494679 15.8947 1.83084 -2792 4 23.7735 16.3203 13.7888 -2.47926 -0.947779 4.85435 -2793 6 43.1303 2.83022 26.0988 7.42094 18.4339 -15.1049 -2794 4 42.3152 3.21229 26.4285 -6.54764 -1.84254 4.96768 -2795 4 43.2129 3.23454 25.2082 4.91034 -11.1878 11.8147 -2796 6 40.68 12.1827 1.56051 12.2683 5.96873 16.2718 -2797 4 41.5968 12.2158 1.84207 12.0551 -6.37233 -9.83141 -2798 4 40.2741 12.5174 2.36876 -21.9125 -2.35909 -10.0625 -2799 6 47.3781 8.09655 26.7608 82.0606 26.064 -7.54845 -2800 4 46.666 7.67998 26.3919 -67.6244 -33.3987 -26.4118 -2801 4 48.0445 8.01522 26.0221 -12.6559 5.80771 33.8866 -2802 6 35.8947 30.7223 38.5098 17.2216 52.6179 -38.6143 -2803 4 35.6523 29.9703 39.0072 10.7188 -28.2359 27.6772 -2804 4 36.8587 31.0199 38.5623 -37.3038 -25.1724 3.03639 -2805 6 51.3054 23.2176 32.4969 -40.2617 11.1267 -4.72183 -2806 4 51.571 23.9803 31.9692 8.10126 9.10595 3.65824 -2807 4 52.0738 22.7076 32.6523 27.5758 -14.8312 4.00399 -2808 6 30.6066 4.44965 39.6625 0.615077 -4.04577 -5.4494 -2809 4 30.9728 3.64581 40.0124 3.38991 -22.1323 -0.234101 -2810 4 30.7691 5.02119 40.3987 0.467535 29.3806 6.08815 -2811 6 35.2584 29.6988 2.86074 -18.8762 -20.4699 -30.2285 -2812 4 35.7444 29.7805 2.00551 -3.31399 -2.84145 17.507 -2813 4 34.478 29.0852 2.62897 29.9452 30.586 13.9144 -2814 6 50.3064 26.1399 9.38994 -11.2342 14.6262 -3.47403 -2815 4 49.9288 26.8854 8.86032 11.0364 -25.2497 6.23881 -2816 4 49.6695 25.4035 9.37359 7.94529 9.32604 -3.86417 -2817 6 50.1026 36.8163 26.4125 -14.5138 -5.51826 -11.285 -2818 4 49.5888 36.0167 26.6617 3.79204 13.187 5.56915 -2819 4 50.2319 37.3727 27.1922 -3.20057 1.11223 6.19844 -2820 6 40.3045 23.9511 38.5442 56.3682 27.7758 -3.16545 -2821 4 40.8125 24.7624 38.7991 -6.5383 -29.3065 -12.768 -2822 4 39.4568 24.2221 38.8139 -44.6373 -1.162 12.0349 -2823 6 24.9504 10.7612 30.6561 23.3702 -4.90777 36.4738 -2824 4 25.6234 10.7245 31.4083 -25.7901 9.07318 -40.0098 -2825 4 24.9126 11.6687 30.2959 1.4184 -10.5997 2.42613 -2826 6 5.89627 1.02238 5.41014 -10.9637 -3.10309 -8.95081 -2827 4 5.14436 0.409378 5.47088 11.7326 -0.810065 6.31118 -2828 4 6.70289 0.529043 5.60145 -0.696658 -1.4992 -0.407558 -2829 6 44.282 29.3718 26.2736 69.4655 -24.0165 25.5627 -2830 4 43.5561 29.7046 25.8233 -49.9183 11.7173 -34.3685 -2831 4 44.8903 28.8623 25.6892 -19.9675 5.54095 9.74148 -2832 6 25.3119 10.1784 6.67292 -15.7736 -23.3412 -3.06725 -2833 4 25.6521 11.0537 6.64576 10.6351 24.7362 -4.37451 -2834 4 25.4625 9.79379 5.79618 6.21987 0.326131 1.26241 -2835 6 13.3514 28.0662 2.56722 45.2358 13.6418 17.9819 -2836 4 12.4545 27.8107 2.56105 -32.9681 -11.4511 -11.8173 -2837 4 13.8041 27.7134 1.79344 -6.10921 -0.687749 -0.120894 -2838 6 6.44709 40.2351 18.0254 21.2427 9.30891 -1.39987 -2839 4 6.966 39.4726 17.7533 0.137807 -7.29984 6.20872 -2840 4 5.59682 40.0602 17.6456 -22.1821 0.316247 -4.7234 -2841 6 47.7944 13.5061 2.01255 -17.6425 -30.8617 30.605 -2842 4 48.2016 12.6358 2.19438 -7.04124 7.54818 -3.24284 -2843 4 48.4122 13.9735 1.50015 28.8905 20.8749 -24.4455 -2844 6 13.5944 20.2974 2.4458 20.0315 11.2691 18.6487 -2845 4 13.7883 19.6075 3.10831 1.39134 9.87367 -8.40212 -2846 4 13.0064 19.8713 1.85297 -21.5499 -10.3053 -19.2062 -2847 6 15.2336 0.850818 36.6661 8.37652 40.6516 -23.9146 -2848 4 15.3117 1.46746 37.4264 -6.40063 -24.0213 -7.24367 -2849 4 15.3514 1.51981 35.909 -6.71396 -40.605 26.1829 -2850 6 33.5971 35.2491 15.0847 71.6425 -10.6997 11.4711 -2851 4 33.8969 35.3297 16.0058 -20.0956 -0.49545 -2.4869 -2852 4 34.508 35.0431 14.6807 -47.978 4.31732 -2.67502 -2853 6 21.7981 9.23698 0.429299 24.0185 -25.5324 29.6504 -2854 4 22.426 9.07175 41.6424 8.6426 -4.20457 -11.04 -2855 4 21.1884 9.81045 0.032847 -35.1273 25.1593 -17.3244 -2856 6 38.1453 27.4709 3.0333 47.9463 -55.6761 10.6859 -2857 4 37.7532 27.3037 2.19157 -17.0599 1.14667 -24.2168 -2858 4 37.8405 28.2288 3.44687 -27.291 50.0057 16.1216 -2859 6 38.8714 27.215 11.7709 41.141 -36.7506 -15.3879 -2860 4 38.9285 26.3434 12.2193 -14.3396 10.7389 0.963039 -2861 4 39.5886 27.0941 11.0922 -22.6073 11.6268 16.0227 -2862 6 29.8734 41.5737 28.6987 15.2279 35.2113 -10.5566 -2863 4 28.9552 41.3162 28.7047 -13.1778 -5.77603 2.88395 -2864 4 29.9141 0.263017 27.9132 -0.896253 -12.9147 16.3719 -2865 6 34.03 8.70777 38.0687 38.5763 27.6628 16.1728 -2866 4 34.8607 8.18924 38.1985 -14.88 11.0383 -8.6682 -2867 4 33.3419 8.15213 37.7593 -24.3719 -27.4308 -8.08559 -2868 6 38.8091 27.3495 30.6738 6.32435 -21.1782 -4.52762 -2869 4 38.5154 26.4386 30.4378 -1.34454 21.7952 1.35616 -2870 4 38.3686 27.5808 31.4849 -11.9448 1.82739 7.69603 -2871 6 41.6473 17.269 36.3639 7.45605 15.5752 1.52238 -2872 4 41.3137 17.162 35.483 -10.4634 0.342165 -15.0979 -2873 4 41.7169 16.3923 36.7151 5.72978 -18.5967 8.16978 -2874 6 30.7243 26.977 35.2074 -15.5404 -28.2563 -3.1326 -2875 4 31.3953 27.4345 34.7177 18.5093 15.4635 -5.31058 -2876 4 30.2206 27.5565 35.766 -0.690558 20.2492 9.56945 -2877 6 47.5414 4.09198 27.2867 -2.42911 13.6608 18.2544 -2878 4 46.636 4.37242 27.4325 -10.4037 -2.52064 9.15115 -2879 4 47.5606 3.99786 26.3497 6.55325 -3.96267 -23.0579 -2880 6 20.946 8.39203 7.27322 -27.8597 -45.7319 -0.818331 -2881 4 20.9365 8.74812 8.15774 -0.207227 20.4039 13.5637 -2882 4 21.4094 8.93893 6.67191 21.7448 31.5979 -18.7028 -2883 6 36.8544 13.691 0.855516 -6.96494 -6.58957 -4.7536 -2884 4 37.3845 13.474 1.605 15.5913 2.53244 29.7992 -2885 4 37.0002 12.9032 0.328977 -4.78774 -2.28905 -12.5933 -2886 6 28.5904 20.2994 26.4544 16.2695 -3.42806 -15.5352 -2887 4 28.4835 19.402 26.1318 -1.12761 -3.3858 2.90642 -2888 4 27.7814 20.5406 26.8733 -22.93 6.76513 15.2817 -2889 6 51.6079 16.8571 33.5121 -4.50033 -4.43314 5.93611 -2890 4 51.6159 16.0837 34.101 -3.91985 -0.958274 -7.09147 -2891 4 50.9053 16.6875 32.8669 7.1497 -2.58651 -2.16023 -2892 6 16.2715 32.0073 37.6936 -41.8913 -21.032 -18.7972 -2893 4 16.4093 31.405 38.4555 0.0363557 12.0183 -19.687 -2894 4 15.4977 31.6058 37.1477 38.3353 16.8511 22.6146 -2895 6 14.3407 25.877 13.2155 1.26588 11.3619 -17.2713 -2896 4 13.5013 26.0279 13.6901 5.40221 7.27027 -0.947788 -2897 4 14.4551 26.5608 12.5093 -9.57117 -0.277473 20.5459 -2898 6 54.9749 28.8768 3.30374 1.15612 -53.5629 -1.59986 -2899 4 54.8083 28.9028 2.3467 2.04661 0.129141 5.0455 -2900 4 0.26744 27.9124 3.48546 -12.4506 41.1861 -2.95604 -2901 6 17.22 5.15598 2.57931 -12.7888 -35.846 -9.7104 -2902 4 17.8674 4.52191 2.91459 -1.87097 -9.90488 -4.08214 -2903 4 17.421 5.9071 3.09191 1.36943 25.6696 10.0797 -2904 6 50.6995 33.0507 10.3154 6.59719 15.9916 42.5002 -2905 4 50.6222 33.8517 9.79386 -1.28667 2.08485 -11.8542 -2906 4 50.7575 32.2667 9.79209 -3.80283 -15.7636 -22.9095 -2907 6 28.8826 19.8405 32.3742 18.5732 17.2051 -15.397 -2908 4 29.8373 20.0763 32.2 -31.4986 -11.6613 7.66973 -2909 4 28.4094 20.6578 32.1253 1.55933 -8.77069 7.582 -2910 6 22.4307 12.8248 23.2991 -20.6917 10.5217 33.6658 -2911 4 22.5556 12.3422 24.1574 -2.40655 13.6672 -16.3005 -2912 4 21.7108 13.488 23.4947 18.3613 -16.8762 -11.246 -2913 6 54.7763 15.5394 8.86893 2.10476 3.1215 13.1486 -2914 4 0.465115 15.309 9.51431 10.762 -2.70861 -3.02895 -2915 4 53.9989 15.1653 9.30174 -3.31272 -0.629746 -12.248 -2916 6 10.4518 19.2967 26.1704 43.67 -11.1159 60.7251 -2917 4 11.2502 18.7163 26.2348 -22.5321 13.8961 -6.48776 -2918 4 10.166 19.2541 25.3007 -24.1973 -3.18459 -58.4054 -2919 6 38.6496 20.2998 35.2325 20.2193 -0.813999 -8.63065 -2920 4 39.5955 20.3672 34.9603 -17.6326 -1.16496 9.70871 -2921 4 38.5782 19.6093 35.9099 2.97533 6.68842 -2.65526 -2922 6 17.4906 18.0487 15.2499 -10.3405 45.0299 20.0184 -2923 4 17.3837 17.5615 14.4531 -8.22833 -15.0257 -32.2828 -2924 4 17.2318 18.9864 14.9797 13.5676 -28.3997 10.204 -2925 6 29.6331 0.960567 26.2796 -25.6031 -26.3316 -72.4206 -2926 4 29.3216 1.74647 25.7973 3.40072 6.61544 23.4347 -2927 4 29.2407 0.266373 25.6265 23.6279 16.4272 47.4057 -2928 6 30.4665 12.6849 28.2971 -10.7965 -27.9245 1.17671 -2929 4 29.8272 13.0822 27.7097 -1.40549 16.7134 -9.61387 -2930 4 30.1324 11.7665 28.3519 9.60572 9.94425 5.65357 -2931 6 36.6695 22.1225 33.3577 39.6017 -11.6369 -25.7224 -2932 4 37.5338 21.6663 33.4931 -10.4393 24.3252 -8.31461 -2933 4 36.1732 21.6976 34.0074 -34.1256 -9.27026 38.9845 -2934 6 34.8672 22.4666 14.3113 -12.0535 -16.0605 -66.2467 -2935 4 34.0349 22.4515 14.7407 -19.1997 11.5289 38.0952 -2936 4 34.5417 22.174 13.4128 25.6484 2.69091 24.3313 -2937 6 15.5262 9.60919 7.44527 49.3682 -27.3699 -19.0187 -2938 4 16.547 9.52246 7.26069 -54.7763 6.57045 5.33777 -2939 4 15.1277 8.71762 7.26288 7.76902 16.5773 17.8238 -2940 6 21.8158 28.0339 19.8054 -4.91607 2.79332 -16.2053 -2941 4 21.8614 28.4614 20.6522 -2.04715 7.82991 15.4338 -2942 4 20.8734 27.9328 19.6183 -0.9528 -10.4666 6.26348 -2943 6 34.5348 24.4247 2.43569 30.4222 -68.2311 14.7367 -2944 4 34.4753 23.4054 2.32054 1.69344 45.6403 0.121788 -2945 4 35.3397 24.4934 3.03523 -29.9154 15.8849 -16.545 -2946 6 12.599 20.9348 33.4989 -13.8827 -5.0407 19.8786 -2947 4 11.7591 20.6911 33.9854 14.8004 1.51093 -27.4282 -2948 4 12.4712 20.9089 32.5331 -6.4324 -2.96843 13.903 -2949 6 45.7737 31.1538 8.70434 -2.26925 11.3362 1.64289 -2950 4 45.9542 32.0869 8.96415 -8.39554 -11.7705 -15.6468 -2951 4 44.8313 30.9442 8.82297 5.93432 7.3758 2.64979 -2952 6 15.4817 22.5529 30.1787 5.69125 -30.6905 2.54506 -2953 4 16.2669 22.9885 30.4865 5.73919 23.8488 1.47991 -2954 4 15.7828 21.6299 30.2043 -15.5749 7.04719 -4.74998 -2955 6 39.7421 17.1743 38.4094 21.5551 17.0277 -9.47446 -2956 4 39.5031 16.7163 37.59 -3.21419 -6.16335 13.1695 -2957 4 40.5012 17.7258 38.123 -12.3818 -10.233 9.13463 -2958 6 13.9944 24.6739 0.675362 16.6213 17.4065 1.77653 -2959 4 14.3534 24.6315 1.57006 -7.52322 -5.04497 4.60086 -2960 4 14.2363 25.5684 0.403337 7.11699 -3.23043 -4.31609 -2961 6 31.5223 19.5616 3.57151 -53.5885 6.24325 20.3398 -2962 4 30.9852 19.2876 4.35912 8.49606 10.2921 -25.2864 -2963 4 32.3806 19.3906 3.88708 44.0272 -8.41539 -5.41474 -2964 6 36.1052 25.07 19.4414 -58.1964 5.4792 30.944 -2965 4 37.0178 24.9674 19.4291 53.7837 8.57858 1.17104 -2966 4 35.8724 24.6048 18.6565 -11.4284 -6.26335 -25.0938 -2967 6 51.6856 17.6883 14.8068 3.37141 18.4291 36.2611 -2968 4 51.7159 18.5692 15.274 12.631 -26.1695 -13.2311 -2969 4 51.0805 17.8845 14.1157 -15.036 4.32684 -29.7308 -2970 6 37.7054 27.4905 38.1961 21.1085 51.9404 -4.50496 -2971 4 37.7442 26.8536 37.5026 -5.7586 -24.9449 -15.2301 -2972 4 38.1753 28.2651 37.7886 -14.569 -23.1779 14.5181 -2973 6 34.7911 13.8542 30.7834 63.814 8.34946 -38.9004 -2974 4 35.1479 14.6416 31.2053 -8.52888 3.60926 11.6955 -2975 4 33.9958 13.5796 31.1473 -54.5977 -12.3598 32.1143 -2976 6 19.6332 37.3754 39.9698 -24.3625 -2.8653 -8.02349 -2977 4 20.5737 37.5051 40.1221 10.6449 -2.37562 -1.97502 -2978 4 19.476 36.9037 39.1231 9.83703 4.21653 7.37417 -2979 6 40.9393 34.0697 21.4586 2.1394 -11.0927 -27.2527 -2980 4 41.1855 34.0244 22.3739 -0.995015 -5.02364 12.6588 -2981 4 40.8269 33.1391 21.1809 -5.56645 12.5591 1.05516 -2982 6 32.9542 27.2131 26.5676 21.8236 31.3611 42.3808 -2983 4 33.7455 27.7378 26.9411 -38.3522 -19.3744 -9.62352 -2984 4 33.2804 26.8388 25.7801 14.7034 -8.88898 -37.5519 -2985 6 24.4045 18.6625 15.6046 15.6323 5.3487 0.0952382 -2986 4 23.6496 19.2317 15.7207 -14.8084 -1.4602 1.41466 -2987 4 24.5649 18.2576 16.462 -0.219489 -3.50303 9.55317 -2988 6 29.9663 1.63299 9.06934 -19.1782 58.0281 -13.4952 -2989 4 30.0652 0.728361 9.20589 6.15764 -53.3299 8.23098 -2990 4 29.142 1.69178 8.53744 13.8409 -0.846673 8.85197 -2991 6 31.4884 20.0987 7.87879 28.0207 -11.7442 -56.0977 -2992 4 31.929 19.6692 7.07379 -7.62771 20.3934 38.6055 -2993 4 30.8102 19.4535 8.0257 -16.4635 -8.90407 20.6678 -2994 6 35.0404 3.79156 33.2694 -1.07326 -4.91424 22.8916 -2995 4 34.2545 4.23611 32.9039 10.815 -2.65177 -4.17514 -2996 4 34.969 3.91026 34.2418 -2.62674 -1.77539 -18.1187 -2997 6 43.9504 7.96546 12.9857 17.1829 -21.9111 0.113786 -2998 4 43.3325 7.29581 13.3448 8.44862 12.3123 -3.96012 -2999 4 43.4563 8.73573 12.7333 -15.1408 11.4953 0.0339333 -3000 6 44.1156 32.6759 16.9403 5.31814 23.9263 4.94933 -3001 4 44.7028 33.4557 16.8081 -6.11209 -18.3833 -3.28173 -3002 4 44.1603 32.5425 17.8901 -3.26507 -3.06823 6.73624 -3003 6 40.6044 27.171 19.0399 5.35236 -7.54795 -39.8413 -3004 4 39.9756 26.4797 18.7399 3.73803 11.5815 8.49028 -3005 4 41.0398 27.5246 18.2027 -12.4172 -8.32437 32.3474 -3006 6 46.047 23.2024 29.047 17.2683 37.2743 26.3298 -3007 4 46.6657 23.8797 29.4684 -18.5589 -27.346 -17.4569 -3008 4 46.486 22.3548 28.9238 8.34839 -6.65718 2.80441 -3009 6 42.6215 30.6103 18.862 -5.01232 -15.325 -26.4249 -3010 4 43.5272 30.7476 19.0895 18.324 11.0008 12.4889 -3011 4 42.704 29.9429 18.1625 -17.0641 3.12823 2.85026 -3012 6 36.1251 10.8932 23.2678 23.6581 36.1082 4.04534 -3013 4 35.2523 11.2865 23.1129 -2.80799 -1.69562 1.02392 -3014 4 36.6983 11.6913 23.4963 -28.2294 -33.6871 -7.78786 -3015 6 13.7386 31.5223 15.7271 -4.49361 3.73805 -16.8081 -3016 4 14.6779 31.7192 15.7387 3.94655 -1.56597 5.72926 -3017 4 13.381 32.0318 14.979 -1.5565 -4.12563 8.0657 -3018 6 33.1703 41.4275 27.7797 10.5813 -15.702 68.4674 -3019 4 32.9714 0.101499 27.0951 -7.66273 31.9341 -41.1766 -3020 4 33.2579 0.043937 28.6255 4.60937 -17.5422 -27.6682 -3021 6 32.9019 22.9042 31.4856 -22.5274 37.748 -5.90861 -3022 4 32.2895 23.1741 30.7829 6.44322 -22.1433 -13.1277 -3023 4 32.7242 23.6662 32.0583 13.0029 -8.58894 11.8377 -3024 6 27.6559 16.8629 6.38841 0.759442 -6.33883 29.8789 -3025 4 27.8611 17.2083 5.54221 8.69809 17.4791 -25.8043 -3026 4 26.8031 16.4594 6.24591 -13.957 -6.38022 2.63501 -3027 6 47.2651 11.6173 26.0576 8.33461 35.0159 47.6166 -3028 4 47.0912 11.6838 27.0214 -5.10661 -22.4254 -22.6877 -3029 4 47.7461 12.4597 25.9756 -3.10554 -9.06377 -24.8427 -3030 6 27.5595 7.06242 7.64189 36.0057 -29.1625 5.70238 -3031 4 26.7484 7.49683 7.83093 -25.0876 11.7282 17.2448 -3032 4 28.0841 6.86482 8.45622 -15.7481 15.6684 -17.1357 -3033 6 39.8009 9.06823 11.973 -19.1879 4.0297 -12.8881 -3034 4 39.4826 9.27056 11.0665 6.39012 -4.37616 15.6201 -3035 4 38.9894 9.1094 12.5089 2.28999 7.64442 -1.09803 -3036 6 18.1977 33.4656 36.103 -47.2434 1.22325 7.58723 -3037 4 17.6693 33.9565 35.4324 13.0563 -6.22307 9.58411 -3038 4 17.491 33.069 36.7104 31.5801 5.82297 -20.8408 -3039 6 37.1917 26.5507 0.720984 -4.45309 15.6177 5.32368 -3040 4 37.3846 25.6567 0.44907 -1.85313 -8.64798 -1.56679 -3041 4 36.2207 26.6114 0.739208 8.96605 -1.46339 -9.13916 -3042 6 44.1887 19.6251 36.8885 40.0452 -6.58607 -3.19327 -3043 4 45.0262 19.1233 36.6753 -25.2412 9.90919 11.1214 -3044 4 44.4881 20.5478 36.9825 -7.95545 -4.32402 -1.12283 -3045 6 27.7744 6.35339 35.6933 13.1235 -8.00403 1.40836 -3046 4 27.1655 6.97567 35.3121 -8.4989 9.93248 -6.95364 -3047 4 27.2748 5.53908 35.7675 0.865215 -2.72076 5.22838 -3048 6 34.7673 16.4826 20.8897 25.0208 -26.1622 5.09639 -3049 4 35.5801 15.8751 20.9364 -40.3091 28.8833 0.638889 -3050 4 34.1629 16.1653 21.5964 8.34467 8.45669 -12.6288 -3051 6 39.0349 20.9701 40.4369 -35.0548 -83.2732 -20.3586 -3052 4 38.7355 20.0763 40.8679 21.616 52.9309 -20.1646 -3053 4 39.3277 21.5521 41.0958 10.956 28.6509 41.127 -3054 6 10.8075 27.9275 1.66251 45.0798 11.5101 -39.3642 -3055 4 10.1207 27.6506 2.20454 -46.3214 -11.9312 37.0665 -3056 4 10.864 28.8887 1.77269 -0.956148 -2.75571 -0.87801 -3057 6 47.0235 23.1304 13.2457 -34.1648 -14.46 -9.62139 -3058 4 47.6809 23.5773 12.718 7.19949 7.22116 -4.18429 -3059 4 46.2703 22.9258 12.6132 27.3011 3.73645 28.26 -3060 6 34.5862 28.4037 10.6629 -11.4192 -4.75939 1.42695 -3061 4 34.4799 27.7252 11.3319 -5.35328 -3.69815 4.40234 -3062 4 35.5403 28.4214 10.6073 9.29856 11.2923 -14.2157 -3063 6 3.3474 17.5828 14.2796 -19.4871 24.8451 -12.2706 -3064 4 3.54237 16.6973 14.5399 7.15819 -24.2504 13.4427 -3065 4 3.84281 18.1577 14.8755 9.98901 -5.90389 -1.38432 -3066 6 27.7213 11.5993 7.52196 5.39723 39.0715 -5.17771 -3067 4 27.6701 12.604 7.61024 4.43832 -37.6789 -1.1729 -3068 4 27.2296 11.2227 8.25132 -2.72363 -3.1191 8.53492 -3069 6 41.4314 28.3382 9.01837 19.0589 -0.973961 -18.7609 -3070 4 40.8555 28.7961 9.62238 -6.75468 20.1798 6.66135 -3071 4 41.7073 28.957 8.28743 -10.8025 -14.2077 17.7393 -3072 6 42.0854 4.7797 8.18851 -21.257 14.5957 -52.3899 -3073 4 42.0432 5.70949 7.81908 14.9695 -22.9802 20.9203 -3074 4 41.8649 4.22501 7.38905 12.6142 12.8494 32.4876 -3075 6 28.4682 8.6325 40.3242 -61.7219 6.47809 -5.55454 -3076 4 27.7379 8.57122 40.9835 27.869 -4.13123 -2.00049 -3077 4 27.8882 8.69791 39.5144 34.8971 -1.31486 9.68376 -3078 6 0.711352 18.2475 15.2828 -1.03732 14.0577 26.4962 -3079 4 1.6037 18.2498 14.9622 18.0256 -6.96047 -13.9963 -3080 4 0.201613 17.7329 14.6701 -10.6254 -13.4061 -11.9404 -3081 6 7.11345 16.2289 40.4432 8.45023 -35.9074 47.1296 -3082 4 7.17312 15.3057 40.7986 -0.221024 11.0765 -27.8146 -3083 4 7.22051 16.6703 41.3088 -5.23596 22.4775 -22.5048 -3084 6 41.0858 8.62552 20.9048 11.0684 -11.3616 26.0286 -3085 4 40.3918 8.42716 20.2762 -10.0062 9.73992 -12.3328 -3086 4 41.3944 9.53753 20.8124 -4.81268 6.06535 -10.7329 -3087 6 31.7073 7.42286 37.542 -14.8479 -9.90339 6.69006 -3088 4 31.4959 7.12404 36.6506 2.47263 0.526998 -6.01676 -3089 4 30.9335 7.11441 38.0458 14.4773 7.59586 -0.291785 -3090 6 40.7266 11.6476 25.425 -35.4896 13.4329 -16.1803 -3091 4 40.7395 12.5913 25.6925 9.9362 -18.5419 -7.18222 -3092 4 41.5423 11.2236 25.6435 22.7694 -4.71413 12.394 -3093 6 29.8665 30.1579 6.66307 26.6562 -4.16721 8.5177 -3094 4 30.5555 30.7343 6.31583 -2.18777 1.73834 -10.5199 -3095 4 30.3573 29.3259 6.76714 -13.2281 -1.59651 -6.45815 -3096 6 40.8439 24.5837 5.68012 15.8615 33.1962 -4.14396 -3097 4 41.3457 25.4223 5.9023 -8.27611 -29.5734 -8.52614 -3098 4 40.1119 24.5659 6.27901 -12.3156 -1.80355 11.8721 -3099 6 34.3917 9.09675 20.4219 17.6262 -1.15942 17.9162 -3100 4 33.57 9.43601 20.7884 -5.86563 4.88571 -3.34935 -3101 4 34.2167 8.80099 19.5352 -13.2656 -6.03918 -15.2606 -3102 6 18.2311 33.5548 26.5354 9.60899 -55.578 -54.4315 -3103 4 19.159 33.2107 26.4405 -23.3884 24.4218 8.45675 -3104 4 18.1621 34.044 27.3085 3.33799 34.4716 53.9641 -3105 6 28.9072 17.4193 26.7965 8.90265 -1.34032 10.3526 -3106 4 28.3267 16.8801 26.2506 -9.53448 5.67773 -5.57268 -3107 4 28.3756 17.7646 27.5432 9.63981 -8.23286 -8.72686 -3108 6 50.4255 35.5446 18.192 14.112 9.6817 -2.74072 -3109 4 50.5661 35.3326 17.2487 -8.6314 -7.47676 15.7559 -3110 4 50.5766 34.7477 18.7329 -11.9848 3.75846 -10.2286 -3111 6 2.99463 21.5653 31.4474 1.68271 -21.0005 -22.757 -3112 4 3.33698 22.262 30.8385 -11.1525 -11.1618 12.076 -3113 4 2.83901 20.7479 30.8788 5.9339 29.1288 19.4027 -3114 6 36.1811 18.7457 8.60665 26.0746 50.7707 2.54435 -3115 4 36.1969 17.9289 9.04749 -6.79937 -48.2248 12.3681 -3116 4 35.6147 18.7828 7.85483 -18.853 -7.00319 -22.0811 -3117 6 20.2934 6.48366 33.7248 -33.7925 -21.1439 9.08779 -3118 4 19.8228 6.33509 34.5702 11.9648 11.0481 1.53323 -3119 4 19.9109 5.73333 33.234 17.8653 6.32962 -8.93867 -3120 6 14.0016 30.5326 6.65439 -2.06342 0.226434 14.1624 -3121 4 14.6658 31.0189 7.18657 -8.4774 -5.82658 -13.2159 -3122 4 13.1556 30.6664 7.11082 5.19683 1.19435 -6.65694 -3123 6 36.2738 16.4523 35.7634 28.7444 28.7466 -1.25628 -3124 4 37.2529 16.3082 35.8444 -30.8138 -2.80693 3.80535 -3125 4 36.1869 17.4417 35.6433 -1.25715 -33.4762 0.326736 -3126 6 45.8255 37.6646 9.68707 16.0609 -41.2042 -13.6418 -3127 4 45.4852 38.2919 10.2717 -20.4348 34.8513 25.7777 -3128 4 46.231 37.0083 10.2774 7.06244 2.74597 -12.4723 -3129 6 47.4229 17.9968 27.6368 -1.79372 -57.0164 -4.60636 -3130 4 47.566 17.432 26.8065 -4.8869 24.4286 27.8294 -3131 4 47.3631 17.3546 28.4089 6.87022 22.2846 -25.0829 -3132 6 25.9574 18.2976 0.964228 23.0858 -4.77958 -10.3735 -3133 4 26.3734 18.9022 1.60725 -19.9671 -4.02324 -2.33442 -3134 4 24.9961 18.2982 0.948557 -9.32218 6.60301 10.8105 -3135 6 27.3657 22.4026 4.28337 1.04907 -15.9856 -17.2206 -3136 4 27.2658 23.3197 4.47064 2.83879 26.7243 10.1579 -3137 4 27.3462 22.4079 3.3181 -1.05974 -10.8362 7.50108 -3138 6 3.39902 3.84297 27.6033 -32.797 -16.937 8.3321 -3139 4 3.87422 4.64571 27.4715 26.6916 15.5682 -1.1402 -3140 4 3.96055 3.06079 27.6076 7.92228 2.5358 -5.38712 -3141 6 45.3564 27.6573 28.835 13.8657 -6.64535 19.4164 -3142 4 44.592 27.1099 28.6295 -10.1072 2.65107 -0.516215 -3143 4 45.3903 28.3299 28.161 -2.22034 5.33578 -9.67936 -3144 6 28.3928 32.384 16.2149 35.1766 -7.36337 1.61596 -3145 4 29.2284 32.2059 15.7054 -23.0821 5.0916 11.0276 -3146 4 28.7076 32.6186 17.1078 -8.03404 1.42552 -9.59962 -3147 6 9.90485 33.8293 13.0286 10.5996 -3.42126 36.647 -3148 4 9.63365 33.2371 13.7754 2.50037 15.8816 -14.8106 -3149 4 9.32864 33.6931 12.2897 -16.1444 -6.90665 -19.0975 -3150 6 38.3335 26.6343 14.9205 -0.551684 -24.4487 3.86314 -3151 4 38.658 25.7334 15.149 1.53578 20.736 -5.06851 -3152 4 37.3858 26.5974 15.0972 1.00556 4.30146 -0.183996 -3153 6 31.3571 16.3836 4.2445 -16.7299 -18.7641 16.8138 -3154 4 30.5501 15.9079 4.56795 14.9054 8.61271 -6.80276 -3155 4 31.2311 16.4593 3.29715 -1.72501 9.16645 -9.12782 -3156 6 6.17482 3.39637 6.55833 17.6941 29.4886 56.031 -3157 4 6.41103 3.08651 7.49149 -7.06328 10.7723 -41.2395 -3158 4 5.9143 2.63963 6.07247 -2.51266 -29.5732 -15.1374 -3159 6 42.5954 13 5.61529 2.6815 -10.2341 6.00586 -3160 4 42.2228 13.83 5.89445 -1.70762 9.74234 -1.3058 -3161 4 43.4476 12.9425 6.06763 3.18432 -3.38396 -9.63491 -3162 6 41.0469 31.4032 33.8032 -2.41258 31.7421 -2.74763 -3163 4 40.7074 31.3974 34.7214 7.44932 1.1292 -16.4995 -3164 4 41.1575 32.3688 33.5162 -1.31614 -41.8694 16.6901 -3165 6 52.8576 12.0626 26.2641 9.5895 -24.4248 -55.9842 -3166 4 52.4684 12.727 26.7939 -19.7064 26.0739 18.5009 -3167 4 52.6066 12.2568 25.3043 12.3637 -4.77707 33.6793 -3168 6 39.2086 4.29542 29.0724 8.4008 5.1904 -7.5125 -3169 4 38.4444 4.85752 29.2861 11.0986 -5.7068 1.32154 -3170 4 39.9986 4.64958 29.5231 -9.05665 -5.78587 -2.57989 -3171 6 3.65769 27.0104 11.285 -33.2394 -3.70913 -3.8751 -3172 4 4.59992 26.8829 11.3514 17.6792 2.33561 -5.11125 -3173 4 3.4519 27.7953 10.7423 10.2361 0.60791 3.91121 -3174 6 41.5441 29.6402 25.2654 2.79284 -4.6021 22.0238 -3175 4 41.8464 29.7038 24.3667 4.04268 2.71218 -16.2057 -3176 4 40.7127 30.1073 25.3399 -6.11251 5.69311 -9.79107 -3177 6 50.4754 27.4974 30.671 -6.87832 -12.1873 7.27551 -3178 4 50.0778 27.1279 31.4799 3.22248 2.82006 -4.01445 -3179 4 49.7824 27.9982 30.2275 0.0461655 4.73 -3.38362 -3180 6 32.7876 33.6322 41.7537 -8.7541 -8.89692 -39.0089 -3181 4 33.1671 32.7559 41.8028 5.47994 -11.5785 5.15438 -3182 4 32.9083 34.029 0.675063 4.83491 15.974 33.6037 -3183 6 5.9806 9.64323 7.93715 4.3965 6.41539 -15.2951 -3184 4 5.77829 9.93579 8.8312 0.6559 3.73469 4.68299 -3185 4 6.3228 10.4083 7.4265 1.56495 -8.59939 9.02132 -3186 6 52.7884 25.3949 27.7 -7.43266 -9.74322 -1.44878 -3187 4 52.93 26.351 27.8747 -0.851616 -24.8244 8.41831 -3188 4 52.9998 24.8518 28.4994 7.3809 16.2458 -18.9874 -3189 6 18.6796 23.2043 14.4609 8.49541 46.7244 28.1607 -3190 4 18.697 24.1166 14.872 -21.1178 -26.825 -16.729 -3191 4 19.5981 23.1771 14.2416 15.365 -21.3066 -15.3625 -3192 6 31.2857 9.07887 13.0786 26.2489 -54.2202 -11.3888 -3193 4 31.3193 8.20519 13.5416 -2.63874 16.5358 -10.154 -3194 4 30.7972 9.64602 13.6278 -24.9284 29.9413 31.6235 -3195 6 52.8163 16.833 29.9704 25.4684 -2.46115 -18.7711 -3196 4 53.1785 16.3479 29.2052 -11.8989 0.938692 6.7974 -3197 4 53.5445 17.4528 30.1342 -3.36222 3.81908 9.3955 -3198 6 13.4835 30.6533 11.9137 -46.9609 -12.8402 15.0292 -3199 4 12.8701 31.2475 12.4314 22.3442 -12.341 -15.3642 -3200 4 14.3315 31.0589 11.9363 20.4041 22.2607 2.0467 -3201 6 24.4145 24.6647 11.1793 -22.2983 -41.6602 -10.5575 -3202 4 25.2113 25.1208 11.3859 27.2622 9.38308 11.5927 -3203 4 24.6402 23.6908 11.0915 -11.4513 27.6962 10.6476 -3204 6 11.1203 26.798 5.92715 -0.288466 28.8994 -0.991584 -3205 4 11.4516 26.991 6.8143 4.21529 -7.59652 -0.673238 -3206 4 11.0194 27.7223 5.58288 -7.6649 -30.4822 0.0195949 -3207 6 12.0071 32.3096 4.57291 -4.86243 14.2275 -68.6847 -3208 4 11.7793 31.9281 3.63093 8.01684 14.4954 56.5286 -3209 4 12.2995 33.2463 4.37904 -4.11207 -26.5611 6.70158 -3210 6 6.4322 5.49281 30.4716 35.2368 -18.2726 5.22228 -3211 4 6.85856 6.3256 30.2181 -6.14256 4.86399 -3.96588 -3212 4 5.49729 5.53619 30.4137 -26.8093 16.306 -3.74387 -3213 6 38.1866 39.6 29.3849 -55.2477 -18.0227 -31.7741 -3214 4 37.4363 40.1798 29.0864 28.3626 1.3397 12.8196 -3215 4 37.8398 38.7214 29.0428 28.3274 26.4583 13.0641 -3216 6 52.5811 19.3636 5.41604 51.907 48.1011 -36.5249 -3217 4 52.4834 20.3242 5.17263 -20.1975 -32.0404 8.71389 -3218 4 53.4908 19.2453 4.99747 -31.6145 -20.6418 25.5541 -3219 6 18.3356 9.8205 21.0747 -17.6268 -29.6196 -17.636 -3220 4 17.8021 9.40634 20.3533 -1.88913 9.35392 27.897 -3221 4 19.0546 10.1733 20.5835 25.9839 20.5094 -7.72749 -3222 6 14.4924 41.1161 15.0432 10.1364 3.71296 -9.89663 -3223 4 15.2732 41.1462 15.6022 9.62288 -5.62086 4.10329 -3224 4 13.9031 41.7078 15.5102 -8.32301 1.75038 3.32266 -3225 6 35.9996 23.9069 26.7492 18.6837 -25.8156 -39.8793 -3226 4 35.9246 23.4421 27.5469 -8.45021 -0.659318 44.9575 -3227 4 36.3072 23.1381 26.2025 -8.08285 36.2837 5.17172 -3228 6 35.634 10.4286 26.2543 -16.0886 -36.8378 31.8954 -3229 4 36.0318 10.4196 25.4062 11.0324 6.64788 -31.8122 -3230 4 35.4344 9.46932 26.4326 4.10196 23.0818 -6.20158 -3231 6 45.3004 24.2842 20.2749 24.2383 10.4641 7.4623 -3232 4 45.3515 25.0535 19.6808 2.20237 -7.91345 -3.22769 -3233 4 44.5434 23.7522 20.0895 -20.4117 -5.11737 -13.922 -3234 6 15.8182 39.0515 24.2407 12.965 16.6456 0.954929 -3235 4 15.3741 39.8779 24.5544 7.5658 -17.411 -0.0196462 -3236 4 16.7724 39.3066 24.1247 -29.8541 -4.22386 6.92178 -3237 6 4.60659 25.9073 16.8122 1.83212 2.60998 -1.97709 -3238 4 5.31562 26.4095 17.2499 -5.00617 -6.2898 0.278133 -3239 4 3.79975 26.4302 16.9186 11.5163 2.87992 -0.585475 -3240 6 33.4767 9.9887 32.5701 -44.5277 -5.18869 -27.5725 -3241 4 34.322 10.1593 32.8843 54.6618 16.656 18.5178 -3242 4 33.0203 9.70843 33.3575 -8.70161 -12.0001 8.14623 -3243 6 22.9321 37.514 1.50284 -0.19108 -28.0604 17.8877 -3244 4 23.0149 38.2279 2.13297 1.92014 9.99004 7.14626 -3245 4 22.7552 36.7067 2.06858 1.19451 21.8657 -20.5647 -3246 6 39.1248 20.5474 25.4766 21.2332 -16.8391 26.0428 -3247 4 39.2186 21.3943 25.0643 2.22233 17.645 -5.02625 -3248 4 39.853 20.5019 26.1611 -16.83 0.667515 -19.8449 -3249 6 25.0699 25.071 37.6104 17.3941 16.9986 -26.7924 -3250 4 25.9994 25.4036 37.6322 -19.4928 -16.3283 1.07636 -3251 4 24.8822 24.8366 38.5108 -1.54859 -5.98321 18.8059 -3252 6 12.2108 35.7702 11.4211 -21.274 -0.450661 -24.3109 -3253 4 11.4942 36.1177 10.8268 17.2098 -2.57945 23.3101 -3254 4 12.7534 35.3113 10.7723 8.20233 4.40137 5.7707 -3255 6 42.0318 15.7212 20.1319 23.9789 -4.66934 -19.8056 -3256 4 42.573 15.4482 19.3354 -11.2719 11.6022 18.1956 -3257 4 42.3198 16.6222 20.3614 3.24172 -2.08619 -3.65764 -3258 6 53.203 25.4276 39.527 3.00787 -13.9161 6.63788 -3259 4 53.7641 25.8569 38.8977 9.18601 6.10619 -8.92001 -3260 4 52.4886 26.0297 39.6953 -12.4398 9.9207 3.51955 -3261 6 53.7999 21.7704 1.29423 13.4333 -6.07506 22.1965 -3262 4 54.6908 21.5389 0.969279 -9.57261 -3.1085 -1.99035 -3263 4 53.3016 22.2177 0.619486 -6.56312 6.61298 -22.2093 -3264 6 1.93757 22.4543 20.1748 -8.22485 -1.41006 19.3874 -3265 4 1.60089 23.2534 20.6505 8.04613 -19.7643 -7.74833 -3266 4 2.27012 21.8339 20.8623 2.42307 18.0741 -7.93574 -3267 6 41.1802 16.179 11.484 -8.24259 53.7733 14.6683 -3268 4 40.8475 15.3772 11.8508 -2.32532 -30.9762 7.10209 -3269 4 40.6167 16.8825 11.9353 16.6943 -22.3779 -21.294 -3270 6 17.1967 38.6113 9.60334 5.35995 -1.86267 -8.12923 -3271 4 17.7852 38.6361 10.3521 13.641 -0.452934 12.0217 -3272 4 16.3282 38.6029 9.98982 -18.6262 -0.708432 10.1602 -3273 6 33.1969 12.9538 38.5484 12.352 25.5713 -8.86638 -3274 4 33.6486 13.824 38.4674 -8.05485 -18.2555 -5.8969 -3275 4 33.0335 12.8861 39.4897 4.37007 -7.66636 -4.23751 -3276 6 24.7228 21.6957 39.9776 0.331302 -26.4697 -8.75647 -3277 4 24.5832 21.6143 39.0045 0.235774 0.581704 12.5709 -3278 4 25.2663 20.9218 40.2505 -4.0265 10.6546 -4.86064 -3279 6 13.577 15.5497 27.3411 27.7809 44.9786 27.5516 -3280 4 13.196 16.0821 28.0648 5.30872 -0.0493108 -10.0398 -3281 4 12.9031 14.935 27.2057 -29.8548 -39.4113 -11.0219 -3282 6 24.6863 18.7248 9.26482 -8.80414 -2.51529 14.0236 -3283 4 25.3563 19.2311 8.7609 -6.6335 -0.338001 12.1858 -3284 4 24.3761 19.0911 10.1338 17.243 1.91927 -22.7003 -3285 6 10.9743 8.21046 0.042398 -18.7759 13.8117 62.0104 -3286 4 10.3469 8.74796 0.639501 28.6352 -16.9877 -21.8389 -3287 4 11.7753 8.08291 0.592641 -4.28958 7.52309 -10.9298 -3288 6 15.7499 31.9609 31.3743 -17.6212 -20.5964 15.467 -3289 4 14.8817 31.9157 30.9761 -10.6343 5.00824 -7.09118 -3290 4 16.0827 32.8403 31.1978 10.1106 0.369155 -2.88897 -3291 6 20.3726 39.1695 21.6147 20.5981 -29.5513 41.0934 -3292 4 19.9726 38.3531 21.9994 -5.82675 23.323 -22.8284 -3293 4 21.1172 39.24 22.2595 -11.0324 14.4144 -20.0969 -3294 6 38.8594 19.5251 7.6091 -6.47304 13.0289 -25.1371 -3295 4 38.0017 19.0955 7.57416 -1.20877 -0.517864 1.64758 -3296 4 39.1744 19.3685 8.48411 8.18586 -10.9486 17.219 -3297 6 41.3695 29.7301 21.1465 -57.7285 -14.4296 34.1578 -3298 4 41.7832 29.6286 20.3251 24.9116 3.74799 -36.1007 -3299 4 41.9865 29.9579 21.8177 26.2541 9.18996 12.3917 -3300 6 50.7039 33.8333 22.0593 7.50244 -20.9835 17.6314 -3301 4 50.9654 32.9474 22.4123 -1.20949 24.7473 -8.4765 -3302 4 50.362 33.6446 21.1779 1.66119 1.27804 -3.63001 -3303 6 18.1671 11.1714 14.3658 -12.4278 -6.78987 13.7569 -3304 4 18.0724 11.2679 15.338 -0.312443 2.59996 -20.4321 -3305 4 19.115 11.0923 14.227 4.83391 -0.924272 -3.79066 -3306 6 48.5058 14.2689 15.2513 -36.7782 -21.7282 -18.3567 -3307 4 49.3677 14.5693 15.4148 44.1026 10.3807 8.68918 -3308 4 48.5803 13.5893 14.5426 -8.44167 10.5166 12.8885 -3309 6 32.9801 15.74 8.25484 19.5805 1.81858 6.30948 -3310 4 33.8151 15.5666 7.78828 -7.72407 0.576521 2.61047 -3311 4 33.2057 15.7253 9.21147 -5.47651 1.26655 -15.0149 -3312 6 42.9141 4.85593 18.7596 35.6338 16.8786 18.3104 -3313 4 43.0674 5.82698 18.891 -14.0493 -22.2454 -3.89051 -3314 4 43.7794 4.50634 19.0974 -23.5505 0.71427 -17.3058 -3315 6 10.488 23.7131 33.4436 27.6073 45.1219 -14.7699 -3316 4 10.638 24.6985 33.3892 -15.3766 -28.1208 6.63949 -3317 4 11.1638 23.4099 32.8243 -6.46894 -14.1785 5.09081 -3318 6 1.12582 20.0662 11.2775 2.81918 8.09367 56.8435 -3319 4 0.488344 19.3589 11.407 -2.14544 -6.99577 -20.9797 -3320 4 1.17571 20.424 12.22 2.69463 -2.11621 -44.733 -3321 6 1.50824 39.5346 14.3079 -5.25271 -28.0543 15.9462 -3322 4 0.868346 40.1487 14.6984 3.61457 -0.641003 -8.28938 -3323 4 1.2571 38.629 14.6571 12.5115 33.2201 -10.0417 -3324 6 8.3332 21.6069 14.1357 -16.8636 -16.8509 36.8071 -3325 4 8.17334 21.0976 14.9962 5.25323 23.3985 -29.627 -3326 4 7.56323 21.4407 13.5807 -3.95337 3.79773 -2.56685 -3327 6 7.16177 13.3249 38.2255 -6.34169 -18.8056 -1.32195 -3328 4 6.69256 13.0329 37.4043 9.76156 12.0715 20.3406 -3329 4 7.43529 14.2522 38.1581 -0.0118119 -11.8895 -14.491 -3330 6 46.6212 1.64167 18.6867 -0.0463537 -24.1078 41.7639 -3331 4 47.541 1.5611 18.992 -0.862753 9.16913 -10.8716 -3332 4 46.1606 1.36736 19.5239 4.43612 14.9978 -24.7224 -3333 6 4.08147 8.39338 14.788 26.1694 13.8207 2.32184 -3334 4 3.41636 8.28931 15.4347 -29.1417 0.0985708 23.0338 -3335 4 3.90156 7.69349 14.1818 -2.47935 -14.3959 -27.3016 -3336 6 47.5712 36.5372 17.8422 14.6219 44.3363 14.3039 -3337 4 47.1691 35.7037 17.6938 -6.70251 -40.3849 -9.96305 -3338 4 48.5299 36.4434 17.8412 5.708 -14.7801 -1.83759 -3339 6 48.7177 32.6293 3.61477 24.5557 -7.82504 -30.2396 -3340 4 49.3183 32.0587 3.09719 0.221751 18.4164 7.83871 -3341 4 48.4066 32.0299 4.25286 -21.3126 -17.4552 36.5328 -3342 6 26.8672 34.4113 15.184 7.18591 -12.831 -4.85448 -3343 4 27.1806 33.7337 15.7866 -5.2278 -3.11582 5.08403 -3344 4 27.3382 34.1395 14.3734 -5.71629 20.1707 6.74573 -3345 6 9.99603 27.3398 13.3337 -11.5184 -70.0362 -20.4383 -3346 4 9.96963 28.1856 12.9595 -3.0362 48.3298 -16.8459 -3347 4 9.789 26.7159 12.5598 12.8825 26.2078 29.4693 -3348 6 2.39106 26.8936 37.3456 -18.0299 -5.48602 7.48259 -3349 4 2.24944 26.7597 38.2955 12.6258 0.126767 -1.18485 -3350 4 3.33209 26.9598 37.1993 18.2818 -0.192027 1.55797 -3351 6 33.3384 17.273 36.7956 -4.69576 6.00605 30.6641 -3352 4 32.3777 17.4022 36.9421 6.35755 -1.66054 -12.3647 -3353 4 33.5147 17.1107 35.8745 -6.55426 -0.461729 -19.8283 -3354 6 10.6704 18.7989 9.29568 -2.62714 4.796 -4.28658 -3355 4 10.7729 18.8103 8.31395 -3.57004 -0.312677 18.1362 -3356 4 10.9356 19.679 9.6198 -4.15772 -1.10699 -11.1079 -3357 6 8.58029 27.4085 3.13543 -0.646896 -38.9365 14.7517 -3358 4 8.62134 27.4642 4.10772 -2.35878 18.0768 -8.00568 -3359 4 8.54298 26.4189 3.06204 -3.80038 30.3142 -4.62402 -3360 6 40.6121 33.9148 14.3433 -13.4775 28.2536 -12.7531 -3361 4 40.8898 33.2957 14.9932 8.13038 -23.145 12.8628 -3362 4 40.1237 34.5547 14.8716 -1.64981 1.12342 -7.13376 -3363 6 54.0126 16.7742 13.6402 -25.2384 12.1291 10.4483 -3364 4 54.0311 17.2666 12.8352 12.7766 5.78776 -30.0788 -3365 4 53.1083 16.9555 13.9311 3.38038 0.740926 17.4694 -3366 6 39.1613 38.4947 7.40674 -49.2832 -1.36929 38.9537 -3367 4 38.8094 38.4839 6.52049 1.87105 5.40513 -14.0728 -3368 4 38.3203 38.5292 7.99504 41.7155 2.10662 -28.5328 -3369 6 42.2152 33.6749 29.0207 -49.4578 14.7313 -27.4402 -3370 4 42.0113 34.6279 28.8262 15.7605 -21.0767 3.4048 -3371 4 41.3749 33.2313 28.6743 34.021 9.03137 24.2205 -3372 6 2.84529 0.06018 20.1342 1.75144 -0.125494 -5.27144 -3373 4 2.85876 0.453048 19.2323 -10.3946 -7.40064 8.89792 -3374 4 1.95714 41.5787 20.3005 13.5701 9.63706 -6.70109 -3375 6 24.9846 26.9367 24.435 4.97654 17.1262 30.4362 -3376 4 25.3707 26.0628 24.5275 -2.48626 -13.7157 -10.817 -3377 4 25.1946 27.3852 25.2847 -1.69157 -3.92554 -20.3381 -3378 6 13.6202 33.989 7.00835 -29.3159 10.7937 -13.6787 -3379 4 14.4707 33.6317 6.76766 5.19255 -3.31821 -12.8703 -3380 4 13.1262 34.2356 6.16936 24.7045 -4.21039 25.9053 -3381 6 17.6361 31.8361 3.38698 11.6752 63.8731 -26.646 -3382 4 17.3765 32.06 2.46015 3.81419 -8.12146 27.658 -3383 4 17.5414 30.922 3.45915 -17.4061 -53.1647 5.72422 -3384 6 31.114 29.8463 35.9142 20.4735 12.0385 -23.871 -3385 4 30.4046 29.6578 36.4892 -25.9224 -10.1565 23.4082 -3386 4 31.8798 29.3863 36.2596 4.49336 -0.641295 3.24883 -3387 6 31.4544 1.69927 1.93203 61.0942 61.1307 23.4408 -3388 4 30.847 1.03155 1.81447 -56.5376 -48.8621 -2.33617 -3389 4 31.1234 2.33851 2.60628 -4.67927 -17.7811 -18.4359 -3390 6 13.7206 9.35179 12.308 -20.4886 -14.5553 22.3614 -3391 4 13.8994 10.2254 12.0406 16.2488 33.284 -13.5816 -3392 4 13.1923 9.47724 13.1212 6.47756 -14.062 -7.29461 -3393 6 15.2915 15.1706 12.1407 -39.3514 -20.6771 -15.8676 -3394 4 14.288 15.1355 12.0691 34.6095 3.19954 13.2467 -3395 4 15.5721 14.5705 11.433 2.70369 1.94224 0.817449 -3396 6 44.9298 30.4448 13.0945 -83.0621 -13.8007 20.4391 -3397 4 45.2326 30.6692 13.9612 22.7288 5.76966 14.7184 -3398 4 45.5619 30.4921 12.4362 58.1466 4.79773 -38.6719 -3399 6 35.1494 37.6283 24.8564 -28.9971 -18.9514 34.2227 -3400 4 34.5453 38.351 25.1691 15.7809 -12.2194 -9.31628 -3401 4 34.8969 36.8477 25.46 15.2444 28.3361 -22.0595 -3402 6 43.9018 19.2999 12.9893 -4.23684 -28.8047 14.7243 -3403 4 43.7111 18.3276 12.9437 8.07938 21.0179 -2.3859 -3404 4 44.434 19.3703 13.8064 -8.2748 4.27416 -6.23054 -3405 6 14.1928 27.3824 16.8974 17.9721 24.801 -15.5057 -3406 4 13.3941 26.8971 17.049 -12.9837 -13.2841 -1.45311 -3407 4 14.075 27.8458 16.0392 0.928992 -14.2323 10.6565 -3408 6 5.07867 37.4759 15.7278 -19.2695 5.34987 61.0101 -3409 4 5.83402 37.4907 16.3496 5.41141 -1.20808 -8.02024 -3410 4 5.40595 37.3511 14.8725 27.2981 -13.142 -45.6678 -3411 6 35.4792 36.9736 33.2279 -33.1303 3.22524 14.2013 -3412 4 36.4062 37.0387 33.1707 43.394 6.70104 -6.41693 -3413 4 35.2647 37.5361 33.9926 -10.1497 -5.08286 -5.32556 -3414 6 6.63713 31.7122 32.9951 -15.6769 -13.4095 -29.903 -3415 4 7.30356 31.0631 32.7808 0.413821 -11.0386 -1.85208 -3416 4 7.01801 32.1732 33.7097 9.96672 21.2943 24.541 -3417 6 31.2686 20.2272 25.4717 1.63607 -11.2998 14.888 -3418 4 30.457 20.1188 26.0175 18.7046 8.55246 -6.40474 -3419 4 30.9671 20.3507 24.5747 -9.02709 8.2981 -6.80006 -3420 6 54.9594 26.0897 7.3541 -26.2324 -3.52234 4.1817 -3421 4 54.3149 26.536 6.76189 8.45344 -4.14623 9.81761 -3422 4 54.4064 25.6921 8.06559 9.60693 6.10548 -13.0393 -3423 6 17.8786 35.1581 24.3912 -48.4608 -31.2574 -23.2844 -3424 4 17.9034 34.576 25.1672 15.4891 12.513 -1.90366 -3425 4 17.14 34.695 23.8716 34.0055 23.8611 10.1154 -3426 6 49.1404 3.30993 19.753 -11.7437 -5.45724 -22.9314 -3427 4 48.7379 4.07245 20.162 -0.785462 12.6857 6.5087 -3428 4 49.8408 3.03849 20.3377 4.84054 -6.57183 8.59361 -3429 6 30.2791 35.6014 13.4902 -0.275976 1.62471 9.45881 -3430 4 29.4038 35.7322 13.1068 5.01216 -3.78726 -8.18413 -3431 4 30.1007 35.4484 14.4302 1.26073 -0.50544 -4.60872 -3432 6 43.3857 25.8788 41.6729 -28.3599 -13.2186 -4.43344 -3433 4 44.0236 25.6058 41.0289 13.0372 -2.28568 -15.7328 -3434 4 43.8192 26.4334 0.378509 18.4346 21.3926 23.5205 -3435 6 21.1033 23.1572 6.40534 -12.8895 6.60285 13.2505 -3436 4 21.2833 23.9599 6.94372 3.68538 -20.4677 -7.26612 -3437 4 21.2354 23.4378 5.50624 8.61756 6.39287 -19.4039 -3438 6 54.6209 21.1977 19.0953 -9.4905 16.5472 15.3455 -3439 4 0.355231 21.543 19.6762 -10.082 -5.94448 -19.8865 -3440 4 53.803 21.6498 19.4211 22.178 -8.62035 -3.94206 -3441 6 13.8696 38.9444 18.7589 -0.408574 -9.95072 10.686 -3442 4 13.5473 38.5195 19.5701 -4.79749 -3.34053 -10.6661 -3443 4 14.2783 39.7511 19.0654 -4.68159 17.5572 -2.41189 -3444 6 39.1837 2.73799 39.6933 -2.22487 -14.248 -19.2211 -3445 4 38.5048 2.18054 40.1045 3.50502 9.25929 9.72195 -3446 4 39.1752 2.3966 38.7788 -3.09486 7.3066 6.14055 -3447 6 43.2236 33.8218 8.83748 -23.7799 54.6507 -8.87946 -3448 4 43.1776 32.9835 9.22653 -2.14792 -45.6212 21.4927 -3449 4 42.4318 34.327 9.18683 27.5752 -12.6709 -4.85681 -3450 6 23.0768 16.6786 12.1043 19.2201 -8.5648 -22.0864 -3451 4 23.4688 16.2415 11.3109 -7.42341 7.06352 19.0042 -3452 4 22.1329 16.714 11.9048 -3.02708 6.60369 6.72608 -3453 6 40.7875 26.1445 36.3165 -31.0446 26.1707 15.63 -3454 4 40.1182 26.8831 36.2336 22.2291 -27.8038 4.66075 -3455 4 41.0346 25.9172 35.4285 12.0382 -0.567557 -16.236 -3456 6 15.1503 11.6728 19.298 -10.8743 -20.3409 15.6657 -3457 4 15.4707 12.2619 18.6272 13.0208 17.9076 -10.0848 -3458 4 15.518 11.9699 20.1418 -0.780585 5.28883 -4.88637 -3459 6 9.8485 29.8084 31.3808 31.6725 31.0987 -15.032 -3460 4 10.6075 30.172 31.8684 -9.75043 -12.6573 12.7307 -3461 4 9.98584 30.2945 30.5336 -20.1344 -22.7331 8.89086 -3462 6 2.12557 30.0341 25.264 -3.96851 -24.8252 -11.595 -3463 4 2.04755 29.1979 25.7442 2.8488 12.5065 4.07713 -3464 4 2.06741 29.7398 24.3306 5.27272 21.1251 20.17 -3465 6 49.0124 10.6515 7.04668 12.8278 -6.79775 19.6819 -3466 4 49.7765 10.456 7.62014 -4.12072 9.88663 -9.32692 -3467 4 48.4954 9.84699 7.16976 -12.5497 -3.43755 -7.74842 -3468 6 38.6385 34.4247 32.4851 8.7415 15.3068 2.26745 -3469 4 38.2449 35.2411 32.8392 7.79483 -2.42751 -9.0272 -3470 4 38.3877 33.7513 33.1114 -5.41613 -8.85245 5.88093 -3471 6 24.2967 24.7175 4.7858 -13.8074 20.2372 -8.25903 -3472 4 24.5879 23.8747 5.12331 8.49271 -10.4438 10.0312 -3473 4 24.0688 25.3355 5.52385 7.10746 -21.4288 -14.6014 -3474 6 44.0211 23.587 33.7713 -18.8641 -18.6234 -6.9532 -3475 4 43.6265 23.0569 33.047 -3.30007 6.44469 22.3225 -3476 4 44.7839 23.9213 33.3479 32.8249 22.1868 -7.88886 -3477 6 45.135 31.9539 26.6318 17.8742 -16.5206 -32.2352 -3478 4 44.6965 32.0125 27.458 -12.8805 4.46476 28.7394 -3479 4 45.0195 31.023 26.337 -1.34861 17.8758 10.4404 -3480 6 52.0545 6.36303 22.865 -1.87051 -30.929 -4.90791 -3481 4 51.4549 5.58836 23.0553 13.7734 29.2588 0.606927 -3482 4 51.4955 7.14596 22.8951 -3.5837 -3.73437 -5.39564 -3483 6 5.1124 17.7016 30.4663 -17.3022 -2.39818 -4.94531 -3484 4 5.57517 17.705 29.6436 5.33167 -14.42 -26.4334 -3485 4 5.6774 18.2653 30.9495 12.7188 16.8745 32.2475 -3486 6 48.5399 17.0091 6.52669 31.3107 25.6813 -22.3666 -3487 4 48.2466 16.108 6.56632 -4.44525 -18.5722 0.0807757 -3488 4 49.3123 17.0767 5.87973 -32.0368 -4.22047 21.2267 -3489 6 13.8017 31.3286 23.4652 -45.3568 -0.340859 23.461 -3490 4 14.0246 31.2001 24.3905 13.6426 -1.74144 -0.768444 -3491 4 14.5269 31.1963 22.8948 44.8358 -8.96568 -14.3918 -3492 6 28.4984 33.4231 26.025 30.2115 45.129 -4.70205 -3493 4 28.7629 32.7421 25.4284 0.749934 -18.6264 -12.7861 -3494 4 27.7356 33.1626 26.4825 -33.9251 -20.2776 22.3239 -3495 6 9.04101 22.9533 11.0101 4.17271 5.63899 8.67886 -3496 4 9.24243 22.776 10.0879 9.05926 -1.29962 -0.957415 -3497 4 9.84172 22.774 11.5341 -6.79246 0.647577 -9.3095 -3498 6 40.5624 4.0706 26.5792 43.7479 -58.1273 15.512 -3499 4 40.0377 4.03321 27.356 -14.6911 0.39925 31.4188 -3500 4 40.1771 4.74143 26.1095 -33.6389 57.2603 -43.6855 -3501 6 17.0606 37.9689 20.9328 24.9068 -2.83666 19.2437 -3502 4 17.7492 37.7057 21.5806 -0.23423 0.332892 -22.3637 -3503 4 16.3 37.9671 21.4825 -28.3901 -0.1668 6.57955 -3504 6 31.9758 6.36253 14.1925 -47.1359 -2.961 8.2158 -3505 4 31.6652 5.47044 14.4516 -0.57512 5.53961 -9.89258 -3506 4 32.9075 6.27907 14.242 33.1863 -3.34593 -3.73058 -3507 6 29.3613 34.9484 39.6522 -7.7658 6.78361 -10.4711 -3508 4 29.4154 34.7255 40.5688 2.48129 -3.65799 19.6008 -3509 4 28.4079 35.1232 39.5563 9.75382 -5.50564 -9.65046 -3510 6 22.5642 2.93231 32.1024 7.89654 -13.571 4.24933 -3511 4 23.152 3.60479 31.7467 -0.797152 8.5773 -0.128413 -3512 4 22.8746 2.10235 31.6905 -8.86372 14.3523 0.842504 -3513 6 51.7365 19.0888 24.8036 24.4352 10.6631 34.2631 -3514 4 52.2011 19.3182 25.6664 -22.8444 -5.9403 -33.5217 -3515 4 52.2256 19.5376 24.1035 -3.13425 5.18677 -1.50107 -3516 6 32.1309 13.661 24.2221 8.32979 -1.22201 -48.3483 -3517 4 32.1718 13.7834 25.1379 3.34806 7.10631 53.6256 -3518 4 31.2192 13.5434 23.9915 -25.9097 -1.66347 2.1781 -3519 6 9.49478 30.1756 28.7975 -1.02802 7.68553 8.51386 -3520 4 8.9614 29.4447 28.4635 3.13242 -3.87437 -3.11369 -3521 4 9.76139 30.7024 28.0341 -4.99689 -6.39164 -2.13333 -3522 6 31.3017 3.1328 24.0821 -2.56057 -13.3126 7.41322 -3523 4 30.8642 3.97896 23.9468 1.03353 -0.10231 -3.56587 -3524 4 32.1597 3.13825 23.6386 1.18226 10.803 -0.447916 -3525 6 2.13915 19.8328 36.4477 43.9795 26.8161 3.66972 -3526 4 3.0929 19.9274 36.115 -41.9598 -16.8793 8.64164 -3527 4 1.76662 18.9777 36.2517 -5.24508 -9.86619 -11.2286 -3528 6 36.9558 16.7701 14.0992 8.10199 -24.1685 -1.60142 -3529 4 37.0878 17.1202 14.9938 -3.44507 3.84646 -3.58016 -3530 4 37.3137 15.854 14.1066 -5.27996 15.1268 -1.92478 -3531 6 1.82451 11.1811 6.08431 4.75441 9.84221 -14.5701 -3532 4 1.68522 10.3449 6.52934 -2.64515 -5.74712 4.44833 -3533 4 1.45572 11.848 6.66197 -6.16769 2.71123 7.45582 -3534 6 43.1467 36.8536 25.2684 -4.34259 -25.2275 5.76074 -3535 4 42.489 36.6679 24.5813 -1.65581 9.08703 8.09798 -3536 4 42.9757 36.1566 25.9418 7.67001 18.3814 -10.5814 -3537 6 32.1358 5.54258 7.00813 -0.159667 5.03525 -3.02009 -3538 4 31.8447 4.70695 7.37259 1.76357 -8.94122 3.22744 -3539 4 31.6184 6.21523 7.45425 -7.92944 5.35442 3.67752 -3540 6 15.0738 21.498 41.5176 2.48253 -6.99424 4.64434 -3541 4 14.4083 21.441 0.286083 -5.89506 -4.91034 13.0846 -3542 4 14.6326 22.02 40.8608 1.523 7.8898 -22.5967 -3543 6 37.0299 36.0573 5.68999 -1.26402 -4.33671 -4.68257 -3544 4 36.8992 36.8706 5.1864 -9.04185 9.38437 4.54051 -3545 4 36.6368 36.1345 6.57983 4.68584 5.64444 -6.17041 -3546 6 39.6378 22.8733 0.344261 -10.4835 1.90991 -1.04201 -3547 4 39.8967 23.7127 41.8596 6.32696 2.65577 1.7872 -3548 4 39.7641 22.9598 1.30287 2.84221 -4.68177 2.22816 -3549 6 18.471 23.1695 5.24444 18.17 13.8994 5.32385 -3550 4 18.2426 24.0888 5.07969 -12.1406 8.45165 -11.681 -3551 4 19.3434 23.2774 5.65727 -5.17221 -14.3673 2.51868 -3552 6 34.4951 26.4012 0.415196 -24.2262 -21.8504 23.5375 -3553 4 33.9567 27.1096 0.873351 15.2264 -25.8266 -5.88921 -3554 4 34.3584 25.5285 0.919462 6.17703 40.7497 -12.3351 -3555 6 28.1538 26.089 40.6186 -44.0465 -12.7539 23.8091 -3556 4 29.0676 25.9468 40.8623 9.74545 0.451611 8.45277 -3557 4 27.5517 25.6856 41.3354 31.2048 15.0133 -28.9196 -3558 6 41.7541 4.40312 30.2348 -21.1804 7.97019 15.7848 -3559 4 42.5951 3.9554 30.1474 10.5948 -6.90465 6.49815 -3560 4 41.6197 4.66064 31.1807 9.39609 -4.15263 -13.0838 -3561 6 4.45746 8.30422 29.123 17.0584 8.0822 12.8675 -3562 4 3.72424 8.78851 28.7689 -20.5564 0.917363 -10.5697 -3563 4 4.90241 9.00738 29.631 2.39094 -12.8625 -4.67793 -3564 6 12.9051 9.61174 32.1485 9.54391 19.7002 1.20842 -3565 4 12.5238 8.90328 31.6499 -4.6135 -18.7028 0.941221 -3566 4 13.4507 9.29961 32.8815 -5.77341 -6.01915 -0.606497 -3567 6 48.6524 16.2364 1.45279 -39.5117 19.3379 22.5337 -3568 4 49.5656 16.3395 1.57323 44.82 -2.42546 -4.76282 -3569 4 48.322 16.6449 2.29127 -2.06599 -18.2277 -23.678 -3570 6 26.4391 39.9942 21.1964 -5.73 55.7886 4.05886 -3571 4 27.1886 40.6225 21.0926 -13.7426 -7.13397 8.25982 -3572 4 26.7825 39.1793 20.9147 12.833 -38.7313 -7.54244 -3573 6 35.8074 4.09236 9.03492 -45.4698 -15.3304 -15.5709 -3574 4 35.5046 4.67089 8.30824 2.24043 1.80806 6.22839 -3575 4 34.9768 3.81452 9.52186 26.5657 10.3238 -8.47709 -3576 6 52.6895 3.55751 27.8666 50.2867 -19.9176 -34.5196 -3577 4 53.5586 3.5996 28.3549 -33.5645 -3.53647 -1.9565 -3578 4 53.0019 3.22463 26.9489 -24.4009 21.759 36.9675 -3579 6 48.3192 26.6913 27.3954 13.1896 -37.7442 -6.45526 -3580 4 48.9722 25.929 27.4853 -22.116 34.446 0.770506 -3581 4 48.7243 27.4862 27.7371 6.43066 9.80699 11.7315 -3582 6 24.507 4.96042 18.7259 -17.59 -10.4057 14.9036 -3583 4 24.0519 4.20246 19.1729 14.2279 16.3534 -10.8515 -3584 4 23.9406 5.7442 18.8517 8.31711 -9.56192 -0.149656 -3585 6 24.0493 12.473 28.7688 20.4432 11.2466 2.34496 -3586 4 23.2439 12.9627 28.9427 -11.3477 -3.77152 -2.6943 -3587 4 23.8404 11.6087 28.4204 -6.74951 -3.90152 -5.01594 -3588 6 40.1637 27.7353 40.8087 -33.5791 -9.4694 0.953173 -3589 4 40.5641 26.9832 41.236 1.78301 2.25495 0.260865 -3590 4 39.2218 27.4214 40.7917 21.7476 20.7917 -9.34619 -3591 6 11.9335 13.5538 26.9488 -1.21599 4.57236 -11.9259 -3592 4 11.0364 13.8177 27.1576 -7.67129 -6.9102 2.53909 -3593 4 12.2164 12.9501 27.6309 4.70555 -13.4351 6.55277 -3594 6 52.1924 29.5424 41.3942 11.5626 -24.8936 -19.0003 -3595 4 51.8104 30.1965 0.050158 4.44506 23.3375 14.6186 -3596 4 53.1351 29.3771 41.6391 -10.5303 1.44862 4.74126 -3597 6 17.4882 19.0285 39.1853 -8.07927 32.7478 0.0743051 -3598 4 17.5012 19.6463 39.9647 -0.891206 -23.8414 -20.0908 -3599 4 17.261 19.5796 38.3923 8.05332 -16.519 21.1694 -3600 6 46.2326 27.6801 33.704 6.45393 -8.86534 7.23017 -3601 4 46.097 28.3723 33.048 -4.6559 5.79968 -1.93617 -3602 4 45.5979 27.7746 34.4233 -3.33861 16.4707 5.34235 -3603 6 35.8364 29.5448 5.62541 9.64171 -18.9009 -6.27826 -3604 4 35.5566 29.3199 4.72548 3.62776 14.0584 -3.56087 -3605 4 35.3944 30.354 5.86953 -6.57081 16.5188 2.47276 -3606 6 47.2881 25.7744 30.172 -6.62968 25.0044 -44.0548 -3607 4 48.1218 25.8653 29.6696 -5.94381 -7.49802 14.0131 -3608 4 46.6882 26.3745 29.6449 8.85802 -15.1094 17.4745 -3609 6 51.3842 12.359 20.0239 24.4626 17.3052 -5.31346 -3610 4 50.8707 12.833 19.3583 -10.0057 -7.98386 3.51527 -3611 4 50.8448 11.6564 20.3722 -11.0446 -8.70835 7.6307 -3612 6 41.976 18.3776 28.9581 25.2971 -7.26912 -18.3725 -3613 4 42.7018 17.9973 28.405 -17.3573 7.64094 3.96866 -3614 4 42.4517 18.9921 29.5246 -2.74764 -0.293653 0.793262 -3615 6 53.6043 6.48027 7.50524 -23.0657 -32.6432 -30.9738 -3616 4 53.1601 5.59498 7.33399 18.2827 28.6912 7.08019 -3617 4 53.6632 6.576 8.44633 9.6706 -3.87944 16.2616 -3618 6 9.90786 10.6094 26.7582 6.17728 8.73826 28.1859 -3619 4 10.299 10.3755 27.6331 -6.59671 -6.24018 -20.7073 -3620 4 9.65116 11.5299 26.9247 0.732239 -5.98194 -12.944 -3621 6 9.31054 39.3957 29.7756 40.7644 23.7808 19.8799 -3622 4 10.1982 39.3563 30.2561 -34.3316 0.809436 -14.8313 -3623 4 8.83679 40.1565 30.1832 5.55001 -15.1294 -12.8037 -3624 6 33.4099 4.77839 0.03236 -17.6047 -18.7695 14.8321 -3625 4 33.6454 5.53147 41.4176 15.8926 12.9618 -7.52592 -3626 4 34.0969 4.09847 41.8942 -0.186489 10.0102 -3.03658 -3627 6 35.7116 10.6673 34.2398 36.7653 -21.2814 -15.2586 -3628 4 35.2554 10.867 35.0388 -18.8422 0.575424 27.4634 -3629 4 36.4577 10.0619 34.4978 -21.6361 17.9445 -5.28322 -3630 6 15.2039 17.4016 19.1867 13.7018 -34.0248 -48.7675 -3631 4 15.5709 16.9982 18.3093 -23.7907 16.5473 43.0322 -3632 4 14.2523 17.472 19.021 -2.02403 4.48523 -0.714523 -3633 6 17.4757 37.6682 15.4227 -5.7624 0.927264 51.2416 -3634 4 17.0409 37.838 16.3209 3.67045 -5.85113 -35.7653 -3635 4 18.3529 37.3927 15.7202 1.879 4.38305 -13.464 -3636 6 26.263 8.20496 21.7043 -12.9193 13.0258 38.8746 -3637 4 26.2935 8.46487 22.6678 13.4631 -3.74504 -28.0146 -3638 4 25.3122 8.09558 21.5911 -4.90698 -1.77416 -12.6216 -3639 6 0.327844 9.89683 15.4174 -28.4002 -4.57955 -27.8061 -3640 4 1.20252 9.6859 15.1701 33.2298 -8.84956 3.25601 -3641 4 54.8213 9.3498 14.7471 -0.695723 21.8052 24.8209 -3642 6 13.451 40.6616 9.29616 -29.1589 -29.1317 3.11657 -3643 4 12.531 40.2581 9.2528 27.9164 27.237 1.6895 -3644 4 13.9533 39.998 9.7876 1.76749 3.89663 -1.50565 -3645 6 49.5605 25.9144 33.0102 6.77982 -23.7672 54.8124 -3646 4 50.0733 25.5846 33.8473 -25.1648 19.9091 -52.5505 -3647 4 48.6275 25.6453 33.15 14.5478 0.915879 -9.46863 -3648 6 37.0796 40.0419 26.4359 -26.9931 13.9721 12.3681 -3649 4 36.1882 39.5442 26.6099 42.8933 36.2545 -2.50818 -3650 4 37.051 41.026 26.6764 -12.8506 -44.3362 -9.04112 -3651 6 47.9916 17.8545 12.1553 -7.21137 29.6324 -37.7219 -3652 4 47.6652 18.6843 11.7058 6.42171 -29.0319 9.52509 -3653 4 47.7397 17.941 13.056 -8.12129 -2.80141 29.1943 -3654 6 27.9724 29.0571 34.165 6.45289 -21.5611 -2.40729 -3655 4 28.8948 28.8211 34.3683 -10.3018 1.8492 -2.91154 -3656 4 27.944 30.0064 34.1676 -0.713497 24.9251 0.854011 -3657 6 33.997 2.77014 13.2231 -35.3168 39.3397 6.14274 -3658 4 33.7592 2.40426 14.0871 -4.38792 -6.80294 -4.34532 -3659 4 34.7545 2.32608 12.931 40.4814 -27.3629 -5.76242 -3660 6 28.4454 36.033 11.4537 -30.811 -5.98685 22.1865 -3661 4 27.9997 35.3658 10.9161 0.521783 -1.73573 4.3727 -3662 4 28.9676 36.474 10.8303 31.7187 19.1344 -28.008 -3663 6 36.1836 11.3675 28.8638 -20.2526 -8.96451 -46.9053 -3664 4 35.201 11.3136 28.8426 17.393 5.15327 13.3727 -3665 4 36.3619 11.2493 27.8855 5.85658 3.26624 29.9739 -3666 6 24.7946 39.4802 16.9069 19.0937 3.96627 -8.4872 -3667 4 24.3751 40.345 16.9988 -5.97342 -3.52606 0.908874 -3668 4 24.9466 39.3518 15.9585 -10.9099 3.48913 2.54936 -3669 6 49.9504 8.05659 22.8451 -38.4139 -9.47108 -34.4931 -3670 4 49.9375 7.9588 23.7925 -16.1787 -3.75115 16.4902 -3671 4 49.0231 7.8493 22.4633 39.8101 3.17892 24.2331 -3672 6 52.1004 19.3469 10.2236 -1.12118 28.0811 1.24376 -3673 4 51.6057 19.3908 9.40186 -4.74475 -17.9853 -5.36861 -3674 4 52.3066 20.3081 10.2872 8.90847 -30.6944 7.30622 -3675 6 24.8344 15.8907 6.13046 -10.5287 3.62194 6.20212 -3676 4 24.2343 16.3288 6.78807 10.5214 -9.32926 -18.7028 -3677 4 24.4584 16.0701 5.24836 4.34413 4.47582 9.48796 -3678 6 49.3142 23.7074 8.6354 12.7826 -64.5552 32.8663 -3679 4 49.2168 22.9153 9.25307 13.1077 36.9849 -24.4484 -3680 4 48.4233 23.9587 8.46247 -20.5325 16.4959 -12.9251 -3681 6 0.200228 10.6387 32.1899 4.57462 9.08702 -50.3173 -3682 4 1.12405 10.3631 32.1441 4.84637 -6.06001 20.7538 -3683 4 54.8206 10.7585 33.0477 -1.25869 -8.0958 33.7963 -3684 6 12.5866 32.9145 13.2359 -45.84 -1.33101 12.3773 -3685 4 11.7384 33.4448 13.1799 26.1773 -16.8128 -1.90055 -3686 4 13.2757 33.4614 12.9111 20.4647 17.7705 -9.07485 -3687 6 21.729 32.5695 14.1172 -9.28791 -20.3928 5.37861 -3688 4 21.166 33.3661 14.1597 2.78901 -9.86158 3.94413 -3689 4 21.3002 31.8069 14.587 7.27427 31.5827 -10.8786 -3690 6 48.1522 34.8482 27.3304 1.15431 -17.6089 -40.5894 -3691 4 47.5385 35.1725 27.9994 -6.04073 -2.93057 -0.479876 -3692 4 47.6796 34.4132 26.5454 8.99615 21.2578 35.6726 -3693 6 45.6357 31.2393 36.095 -40.8957 20.4658 25.2026 -3694 4 45.8476 31.9489 35.493 1.2761 6.76392 -14.6383 -3695 4 44.8829 31.5945 36.6582 19.8537 -10.4851 -18.3708 -3696 6 46.2846 0.316369 14.3569 -23.6541 -29.5796 11.0344 -3697 4 46.2347 1.24867 14.1822 6.12226 14.592 -0.646978 -3698 4 47.172 41.8876 14.3137 22.6277 5.76419 -11.0491 -3699 6 14.3437 18.9821 40.2104 -25.2995 -33.3041 -15.9392 -3700 4 14.4094 19.2869 39.3238 4.54227 2.45102 -23.4893 -3701 4 14.593 19.7098 40.7196 18.3341 34.8836 33.2243 -3702 6 14.5595 1.13832 10.2184 21.0915 11.237 11.4523 -3703 4 15.4791 1.15983 9.85648 -24.9846 -0.242798 0.374642 -3704 4 14.0639 0.416501 9.81608 3.47586 -8.24251 -5.69878 -3705 6 34.4238 40.9137 13.0059 -4.24882 -26.6665 -25.0696 -3706 4 34.0907 40.4301 12.2099 6.6876 25.2293 12.1693 -3707 4 34.3655 40.2093 13.6737 -1.45879 20.9599 -0.365544 -3708 6 42.1372 25.6317 33.9946 32.9644 -29.1434 -4.32848 -3709 4 41.7256 25.3671 33.1599 -4.34041 1.82357 5.58197 -3710 4 42.8775 24.9612 34.1276 -26.6125 21.4128 -4.76888 -3711 6 29.2041 22.5904 40.0709 -12.2401 -3.24737 -11.2113 -3712 4 28.5312 23.0545 39.5673 2.40343 6.95864 -1.48823 -3713 4 29.0042 22.7646 40.9807 1.44808 0.219743 17.343 -3714 6 44.8039 18.6198 1.5029 3.83338 16.5679 14.3409 -3715 4 44.9659 19.0204 2.39019 -3.90529 -17.866 -14.3425 -3716 4 44.0478 19.1074 1.16429 2.25905 3.06151 -3.31671 -3717 6 4.48486 10.8191 23.9456 -47.6019 -35.9978 3.19751 -3718 4 5.13394 11.3869 23.6113 33.8353 31.137 -11.4748 -3719 4 4.52769 10.7271 24.8961 2.68899 9.9192 5.78369 -3720 6 6.46393 23.0191 29.0034 23.802 4.69353 23.6764 -3721 4 7.14249 23.0161 29.7285 -18.6834 17.7038 -21.9419 -3722 4 6.49076 22.0968 28.8008 -10.0115 -22.5628 -12.4771 -3723 6 39.7912 25.1434 32.5739 17.5205 -18.6836 -60.5647 -3724 4 39.6128 25.3468 33.4485 -16.6712 22.7672 53.7369 -3725 4 39.6667 25.9357 32.0325 -1.3786 -0.359445 4.68486 -3726 6 40.844 21.4875 8.87812 10.6958 -1.16061 -24.4784 -3727 4 40.753 21.3778 7.91779 -6.86728 3.07162 8.13114 -3728 4 41.3272 20.6946 9.13123 4.7165 -6.17308 11.2164 -3729 6 0.614957 1.42802 12.9561 35.282 30.4207 -35.1483 -3730 4 54.8795 1.90166 12.5287 -4.84596 -15.7095 11.3484 -3731 4 0.325279 0.716474 13.4972 -22.2917 -16.9379 18.816 -3732 6 32.6687 29.7155 23.4821 0.172893 -14.8348 21.3896 -3733 4 32.2937 28.8037 23.5347 8.27316 18.2339 -7.75927 -3734 4 32.5776 29.9928 22.5742 -5.86304 -0.191283 -15.879 -3735 6 12.5314 37.1515 20.4729 45.6241 64.5302 32.6184 -3736 4 13.0675 37.1561 21.3077 -14.1528 -0.638655 -18.1117 -3737 4 12.0966 36.3476 20.454 -27.4762 -63.6198 -6.10217 -3738 6 13.8924 14.5151 24.69 -3.15938 -4.02598 20.115 -3739 4 13.491 15.2498 24.2338 -4.44789 9.69439 -9.34194 -3740 4 14.0279 14.8194 25.6039 -0.281954 0.872924 -9.09093 -3741 6 17.5021 27.063 26.4741 18.9499 -7.93165 -17.7551 -3742 4 17.3645 27.9616 26.0981 5.20292 -20.1733 2.46217 -3743 4 18.105 26.551 25.8503 -19.0729 23.9469 15.4793 -3744 6 54.4877 9.53021 26.3477 -5.78247 7.96784 25.4661 -3745 4 54.0512 10.3733 26.628 8.34027 -15.1138 -9.49744 -3746 4 54.8923 9.139 27.1544 -8.60221 9.32804 -13.3813 -3747 6 33.6807 21.5011 24.9225 20.8165 12.7411 -37.5161 -3748 4 33.6447 21.5342 23.9109 -0.857654 -11.0597 35.2787 -3749 4 32.8481 21.1477 25.2212 -19.5227 -6.82771 5.56304 -3750 6 22.1475 35.2701 2.885 -1.57378 -2.18642 30.1771 -3751 4 22.1887 34.3602 2.5781 3.09514 -3.18559 -9.19859 -3752 4 22.1072 35.1817 3.87164 0.12039 0.813186 -18.6146 -3753 6 45.3027 5.41438 15.6133 24.4211 -32.124 17.7203 -3754 4 45.2073 5.06649 16.5292 -4.89018 16.6426 -14.7318 -3755 4 44.541 5.92364 15.3615 -17.3903 4.72304 -1.03383 -3756 6 5.67534 7.5869 16.981 -5.47297 6.8358 -20.2139 -3757 4 5.25896 7.81046 16.1225 6.35918 -0.232773 12.9215 -3758 4 6.51331 8.07041 16.9918 4.7107 -6.94883 2.60141 -3759 6 34.576 39.0992 27.2053 24.5889 13.5844 -33.9491 -3760 4 34.3093 38.4547 27.8221 -16.0328 -19.2876 29.327 -3761 4 34.0621 39.904 27.3046 -7.96056 4.01318 13.6593 -3762 6 32.7541 33.6107 34.2903 -12.2088 11.6467 -22.6039 -3763 4 32.1008 34.0277 33.6489 27.9813 -13.6615 23.3944 -3764 4 32.6574 34.0489 35.1447 -11.8345 -0.637226 -0.957772 -3765 6 31.0088 41.2052 32.3952 -16.5884 -4.13679 -5.08533 -3766 4 30.2065 41.1942 32.9317 -1.71273 -1.00977 6.80252 -3767 4 30.9738 0.147898 31.9828 5.47722 15.337 -6.15299 -3768 6 7.65161 1.58314 27.1492 34.9115 -9.04616 -23.8477 -3769 4 8.49581 1.43905 26.61 -35.9655 -7.00487 18.1392 -3770 4 7.51162 2.51613 27.0476 -4.48076 16.5289 1.77021 -3771 6 0.884173 22.0999 37.8474 19.5684 -22.3581 -15.9684 -3772 4 1.29289 21.3236 37.3582 -15.3878 24.821 16.8607 -3773 4 1.19208 22.8872 37.3739 -1.97361 -3.14502 -0.467946 -3774 6 7.41204 11.1157 19.2314 -38.1481 -15.0427 -1.85178 -3775 4 7.53858 12.0593 19.2468 12.5581 17.6457 8.19935 -3776 4 8.2604 10.6916 19.3015 17.9889 5.14781 -4.65775 -3777 6 43.7858 12.4956 37.3097 0.920036 9.73958 -3.1733 -3778 4 43.9612 12.5094 36.3537 -0.436236 -2.21513 6.60981 -3779 4 44.6264 12.7918 37.692 -0.443403 -7.75914 -0.361508 -3780 6 29.0868 33.5248 36.1867 6.33086 18.8505 -43.8567 -3781 4 29.87 33.99 35.8176 -18.9328 -5.41066 10.4629 -3782 4 29.4633 33.0358 36.8874 15.3521 -14.5291 31.9885 -3783 6 14.802 4.59099 3.93345 20.4849 22.8827 12.2406 -3784 4 14.3757 4.0439 3.27797 -5.14737 -6.71868 -8.73832 -3785 4 15.6594 4.91612 3.57855 -16.4986 -14.1515 -5.85747 -3786 6 39.0551 6.39795 6.38864 -31.6963 1.09254 42.8867 -3787 4 39.3692 7.21691 6.04781 17.6944 18.3081 -17.2196 -3788 4 39.3538 5.69048 5.84285 10.6785 -8.50098 -20.4551 -3789 6 22.2123 37.9977 40.776 -14.7699 -23.2033 -28.4168 -3790 4 22.4586 38.8695 40.5021 9.68098 25.7962 -2.3277 -3791 4 22.4791 37.9118 41.6765 7.85923 -2.07179 26.9545 -3792 6 4.44877 23.2867 6.14309 -1.92846 -21.7963 14.7751 -3793 4 3.85981 23.8785 6.59389 -8.34079 22.3777 -5.30491 -3794 4 4.15148 22.4458 6.53602 18.5324 -1.87236 -10.5169 -3795 6 12.4298 23.7885 9.24819 15.5635 1.24594 19.7483 -3796 4 11.6299 23.5219 8.81427 -22.2296 0.449899 -3.14002 -3797 4 12.2156 24.1823 10.1208 2.55292 -1.37139 -18.7826 -3798 6 46.4922 15.2589 16.9667 3.22745 3.94864 2.0367 -3799 4 47.1791 14.9867 16.3488 -1.59454 -10.7105 -10.6804 -3800 4 46.8221 16.1143 17.2497 1.89409 2.98219 12.0057 -3801 6 34.1117 27.1644 19.7797 24.4736 -11.2812 21.2279 -3802 4 34.8774 26.5238 19.7962 -19.6491 14.1094 -6.20677 -3803 4 34.0324 27.4806 20.6991 -2.21978 -4.312 -16.0235 -3804 6 46.9479 13.2121 35.1109 14.7829 18.0264 15.8687 -3805 4 47.3232 14.0654 34.8894 8.1348 3.75559 6.81177 -3806 4 46.5576 12.9943 34.2929 -17.7211 -19.0679 -23.646 -3807 6 50.5883 18.7922 12.536 -4.97475 -8.40096 -18.6689 -3808 4 49.7377 18.4417 12.2063 9.85466 0.19572 8.20723 -3809 4 51.2037 18.6585 11.7837 -7.44169 10.1395 9.07394 -3810 6 32.4871 12.6357 31.9554 3.75694 -28.5712 -45.9238 -3811 4 32.607 11.6542 31.8864 5.47128 21.8321 9.55763 -3812 4 32.4011 12.8494 32.8587 -4.02679 2.16968 41.7104 -3813 6 6.20502 19.6778 10.0162 1.71901 21.9334 16.0314 -3814 4 6.41826 20.2441 9.25697 6.75258 -1.0862 1.44387 -3815 4 6.08129 20.3112 10.7738 2.93045 -16.0896 -19.0741 -3816 6 21.5254 21.5246 2.44441 10.1652 3.23891 -24.6245 -3817 4 21.7373 21.5014 1.49425 -3.90993 5.22039 4.49463 -3818 4 22.0841 20.8004 2.76184 -10.1442 1.98878 12.5692 -3819 6 38.3901 23.0895 17.1987 11.9637 -29.1373 -23.0023 -3820 4 38.7115 23.1739 16.2902 2.30233 23.4463 5.8212 -3821 4 38.6091 22.1461 17.2941 -10.4226 8.48715 23.8901 -3822 6 29.6992 24.9636 22.2212 38.6917 -37.4999 -9.7813 -3823 4 30.2244 25.0209 22.9989 19.9484 -5.9881 25.7874 -3824 4 29.0295 25.5321 22.4534 -63.588 46.0104 6.14599 -3825 6 30.2959 21.4331 37.7732 -36.6703 24.7369 -1.55525 -3826 4 30.3833 21.3736 36.7928 -5.6984 1.01251 23.2154 -3827 4 29.3642 21.7906 38.031 44.833 -25.8334 -23.6526 -3828 6 11.8968 11.712 16.3062 -52.2626 -16.509 -42.1992 -3829 4 11.3487 12.2512 16.8737 -4.04714 4.99791 6.8918 -3830 4 11.2749 11.5458 15.4981 35.5887 6.11969 38.645 -3831 6 5.69762 16.9728 10.4703 1.06122 -0.586779 5.28994 -3832 4 4.99177 17.1708 11.0979 -1.96678 -11.04 -5.71485 -3833 4 5.85288 17.8179 10.0528 3.40155 4.97172 -3.96907 -3834 6 41.7052 34.1635 35.8846 2.77529 22.9845 38.2917 -3835 4 41.9958 35.0267 36.2582 -8.6238 -19.1969 -5.00662 -3836 4 41.6615 34.3005 34.9574 -2.57818 -0.630621 -34.674 -3837 6 33.7668 1.16041 30.1021 -7.73366 -5.3538 60.0773 -3838 4 32.8437 1.27671 30.3431 -6.56672 10.3256 -18.6068 -3839 4 34.0939 1.04339 31.0463 15.1522 -1.22783 -40.312 -3840 6 50.3589 18.6227 36.9888 29.2523 22.0538 -2.88024 -3841 4 50.1022 18.8636 37.8788 -6.7252 3.81489 7.59342 -3842 4 49.7597 17.9698 36.6907 -30.5426 -29.286 -11.4073 -3843 6 24.6818 24.2557 40.239 -30.3362 18.6852 9.52233 -3844 4 23.7683 24.4347 40.5809 21.1328 -2.57181 -5.50386 -3845 4 24.791 23.3075 40.3447 2.5826 -1.14956 -5.51696 -3846 6 37.3025 22.0306 23.2304 -1.24857 -1.55203 26.5345 -3847 4 37.0034 21.8174 24.1364 -3.77965 7.42086 -11.5868 -3848 4 37.7677 21.2337 22.9852 8.84969 -1.31238 -13.2672 -3849 6 48.4163 40.4951 28.9695 -6.68628 11.813 -16.9736 -3850 4 49.0084 41.2243 28.7075 -10.6266 -4.31108 -6.63999 -3851 4 47.6767 40.479 28.3098 12.2088 -0.876211 11.6705 -3852 6 24.8524 8.74511 16.566 -5.47802 -1.24744 16.6444 -3853 4 25.3154 9.32041 17.1898 2.58295 -0.80606 -7.28092 -3854 4 25.3735 7.93816 16.4942 1.51819 -5.71343 -7.74972 -3855 6 19.2312 23.0154 32.4581 7.29767 -10.2486 -2.08042 -3856 4 18.4295 23.4489 32.1618 3.75321 4.57429 -6.83594 -3857 4 18.9208 22.4103 33.1253 1.01223 -4.21105 8.69504 -3858 6 3.33807 21.6805 22.4551 -46.3933 -7.60477 16.0737 -3859 4 2.65604 22.1286 23.0335 23.3212 -20.9163 -13.0515 -3860 4 4.02869 22.318 22.3903 27.1551 13.0827 -5.07429 -3861 6 10.2258 20.3371 12.829 -8.54969 -20.6717 -8.68144 -3862 4 9.56384 20.8338 13.3253 4.28314 2.73019 -3.94148 -3863 4 9.70568 19.6401 12.367 8.3544 15.6282 9.01344 -3864 6 9.53393 0.668964 25.3385 8.23748 17.1946 -9.08311 -3865 4 10.3992 0.538209 25.8183 -20.1327 16.9559 -17.4439 -3866 4 9.57635 1.38514 24.6117 12.9812 -33.3008 29.4344 -3867 6 10.6624 40.712 9.64369 -16.6479 -8.09828 -30.6343 -3868 4 10.6692 41.3905 10.303 1.51816 10.4523 18.0663 -3869 4 9.97599 41.0031 8.99599 12.0328 -9.66263 16.6565 -3870 6 46.359 25.2248 32.6769 -14.7838 37.2607 37.796 -3871 4 46.1367 26.0735 33.2154 13.6855 -48.6436 -31.9122 -3872 4 46.6282 25.5659 31.8216 4.36769 -3.83668 -6.22015 -3873 6 38.9431 3.2028 23.1016 18.0409 -17.6687 24.963 -3874 4 38.0396 3.32435 22.9005 -28.138 13.963 -19.732 -3875 4 38.8834 2.64883 23.9052 13.1186 5.8311 -6.82495 -3876 6 33.334 23.6417 36.8871 -1.6197 -14.346 14.9842 -3877 4 32.7695 23.6175 37.7211 18.6046 10.6207 -30.6843 -3878 4 33.5528 24.5621 36.6745 -4.59115 1.63353 1.59233 -3879 6 51.9355 33.3272 25.435 24.4931 61.1901 -39.0042 -3880 4 51.4286 33.1494 26.1943 -20.5556 -13.8295 37.3068 -3881 4 51.9313 34.3506 25.3627 -2.33157 -52.0679 -5.38276 -3882 6 32.1777 25.0215 33.1655 -4.40266 21.2191 -9.05445 -3883 4 32.7541 25.8194 33.0841 -10.7751 -17.7804 3.95932 -3884 4 31.2703 25.3891 33.0319 13.5135 -10.8842 0.697404 -3885 6 51.2858 27.7149 39.5023 -29.438 -28.7732 26.1015 -3886 4 51.6029 27.7352 38.6212 16.0201 9.86215 -30.6452 -3887 4 51.6337 28.456 39.976 12.6328 17.4546 7.30145 -3888 6 34.2938 28.319 17.2582 8.1769 -6.30709 4.0332 -3889 4 33.5147 28.7567 16.9609 -27.2201 13.5182 -7.119 -3890 4 34.2215 28.3851 18.2119 5.48963 -10.3892 10.8325 -3891 6 36.9125 8.03614 37.8626 31.6258 41.6511 37.5008 -3892 4 37.1772 8.64874 37.1722 -6.23292 -16.4311 -22.0997 -3893 4 37.3691 8.52088 38.6203 -30.9712 -36.3395 -15.9768 -3894 6 34.8794 19.4073 6.12479 12.5531 6.66298 1.29528 -3895 4 34.0931 18.8687 6.15723 -9.84615 -2.81902 0.903663 -3896 4 34.5874 20.3343 6.07707 7.75337 -1.04832 -3.72421 -3897 6 52.9388 9.46792 7.82791 49.0384 32.8563 -49.3294 -3898 4 52.8922 10.1625 7.06425 -6.6048 -31.3865 41.9454 -3899 4 52.145 9.34409 8.30569 -37.6802 7.72308 13.142 -3900 6 36.3078 5.4787 38.9756 -59.3492 -35.3574 -23.3076 -3901 4 36.7604 5.44249 39.7856 34.2456 7.44664 27.0781 -3902 4 36.4713 6.28646 38.5283 19.3627 32.146 -13.2298 -3903 6 10.0102 14.4476 13.47 7.45507 32.9986 11.9551 -3904 4 10.2267 15.3574 13.7991 -6.33005 -21.0964 -5.42394 -3905 4 9.26267 14.5991 12.8847 -7.70629 -5.78085 -0.713961 -3906 6 17.2158 24.3617 39.7859 1.82925 -26.4802 17.5225 -3907 4 16.9252 25.2477 39.6578 -10.2532 23.1813 -8.78866 -3908 4 16.8659 24.1409 40.6742 12.3143 -2.49802 -8.33055 -3909 6 49.0708 32.5605 7.76617 4.98775 -19.9892 12.4117 -3910 4 48.2488 33.0406 7.85919 -4.66971 4.38963 1.84033 -3911 4 49.5854 32.9586 7.08254 9.03816 10.9607 -18.1455 -3912 6 44.8772 24.3958 5.47001 55.4245 15.4507 -4.26518 -3913 4 44.8128 24.5742 6.41303 -16.1158 -0.171295 7.10823 -3914 4 44.0866 23.9971 5.17679 -42.0653 -18.1716 -4.3799 -3915 6 37.3106 29.1913 32.8596 13.2918 -7.82588 25.4298 -3916 4 36.7195 29.353 33.61 10.148 2.43022 -0.346483 -3917 4 36.7915 29.3572 32.1043 -27.5405 3.64351 -29.7293 -3918 6 0.903259 24.8209 21.2384 21.1637 23.8586 -12.5999 -3919 4 1.07153 25.1845 20.3306 -6.36458 -4.90686 24.2304 -3920 4 1.48599 25.3539 21.839 -15.2813 -16.355 -7.82064 -3921 6 53.0335 2.20305 13.0061 -8.76459 0.917863 -30.1717 -3922 4 52.7178 1.83592 13.8181 -1.16689 -4.66991 20.3458 -3923 4 53.3973 3.07458 13.1779 4.70755 1.41814 13.7418 -3924 6 24.3073 33.9788 13.9425 26.9643 -19.8352 3.53447 -3925 4 23.8166 33.1535 14.1304 2.48225 11.7572 -2.64876 -3926 4 25.2622 33.8278 14.204 -36.1259 9.29052 -3.07765 -3927 6 40.931 19.3008 0.314297 -22.2267 40.7784 4.53314 -3928 4 41.073 18.3876 0.266006 15.5735 -49.6404 -1.39225 -3929 4 41.7685 19.7545 0.415523 11.1161 2.19254 -0.550631 -3930 6 38.3131 32.0321 21.5909 -11.558 27.6654 -12.3629 -3931 4 37.7152 31.3901 21.181 3.54948 -0.803384 -4.61225 -3932 4 38.0485 32.9451 21.2634 6.02672 -33.9485 15.0266 -3933 6 42.3093 34.9988 16.9782 -31.0886 21.3467 -4.04435 -3934 4 41.4322 34.9872 17.4259 23.1708 5.16072 -1.2535 -3935 4 42.7209 34.172 17.1456 10.0707 -23.8474 2.85212 -3936 6 19.5555 24.3301 21.9337 4.81064 -45.312 41.7565 -3937 4 19.0503 23.5208 22.2695 18.6897 32.4519 -16.5084 -3938 4 18.9494 24.7901 21.383 -21.2783 9.24005 -16.3011 -3939 6 21.0765 3.08453 14.9497 18.8565 6.62045 0.482113 -3940 4 21.9827 3.42458 15.1377 -20.4059 -2.71097 -2.70114 -3941 4 21.0593 2.94323 13.9894 -7.00518 -5.35814 1.95693 -3942 6 16.4422 12.1477 28.531 -0.750899 4.00912 3.87665 -3943 4 16.9503 12.6102 29.2147 -1.62139 -0.392447 -5.94721 -3944 4 15.8278 12.7952 28.1633 1.40376 -4.03425 1.22377 -3945 6 29.5501 4.7113 21.752 31.6763 -19.7408 -11.7502 -3946 4 29.7575 3.81476 21.3864 -8.62397 20.1371 9.94028 -3947 4 28.6767 4.97136 21.4837 -14.307 1.15287 -5.34284 -3948 6 47.4015 12.0887 13.4082 -20.234 -20.0739 19.2385 -3949 4 46.7896 12.1748 12.658 5.24956 2.33261 8.08179 -3950 4 46.8763 11.6307 14.143 25.8489 23.9178 -32.3489 -3951 6 26.4368 0.034911 5.58657 -64.7941 -10.5287 17.818 -3952 4 25.4579 0.386547 5.64311 57.7785 -5.53424 -8.5606 -3953 4 26.2825 41.0177 5.90114 11.1228 18.2746 -10.9356 -3954 6 20.8239 34.8091 41.3451 3.02448 22.7042 23.7072 -3955 4 20.8848 35.7307 41.7064 -1.83719 -23.2001 -12.5561 -3956 4 21.5135 34.3024 41.8142 -0.435548 5.34794 -5.15218 -3957 6 12.6914 17.4806 1.38079 -1.22179 11.8948 19.0955 -3958 4 12.6924 17.2614 2.32235 1.20892 0.120609 -3.36771 -3959 4 12.6119 16.652 0.923905 -0.609755 -13.5185 -16.0456 -3960 6 30.0783 10.198 8.41195 2.12134 -1.25171 -25.3141 -3961 4 29.3533 10.7626 8.0964 5.01977 -3.23694 0.534487 -3962 4 29.9182 10.0601 9.33268 -3.94599 -2.47727 24.1034 -3963 6 36.3506 5.44781 23.9083 -0.549638 14.3818 20.7021 -3964 4 36.0156 6.32048 23.6328 6.62881 -2.58855 0.476976 -3965 4 37.0027 5.63115 24.6267 -8.58297 -8.41851 -13.9364 -3966 6 34.0301 39.9488 19.4964 -23.0399 -20.8249 18.5921 -3967 4 34.456 39.4415 20.2152 6.93565 15.6495 -14.2212 -3968 4 34.6348 40.5483 19.0534 11.5364 2.12704 2.14354 -3969 6 25.0981 29.0133 17.0022 63.4673 53.603 -24.6749 -3970 4 24.4066 28.4545 17.2066 -49.3728 -47.1307 14.2315 -3971 4 24.9323 29.3693 16.11 -4.01222 -10.2038 10.3173 -3972 6 28.4991 21.3215 6.5284 30.3134 51.3135 12.4116 -3973 4 28.073 21.8131 5.82363 -12.0684 -17.0718 -17.6117 -3974 4 29.0439 22.0969 6.88435 -18.1485 -38.7813 5.23359 -3975 6 18.6639 26.1486 0.434559 17.278 41.4043 -10.2832 -3976 4 18.2934 25.3073 0.618971 -26.4426 -25.2614 5.85754 -3977 4 18.1648 26.8598 0.892557 2.28699 -17.4047 3.2853 -3978 6 10.9881 29.7025 15.4563 -76.0882 18.6105 19.9394 -3979 4 11.66 29.3744 14.945 58.6215 -25.2203 -34.7363 -3980 4 11.3165 30.0451 16.2682 18.0847 5.23212 20.5617 -3981 6 33.4842 3.75768 10.5858 0.636803 10.5574 28.6939 -3982 4 33.4734 3.50079 11.5612 -0.522502 1.02567 -36.066 -3983 4 33.5593 4.73652 10.6 -0.068286 -14.4363 0.33475 -3984 6 12.2823 28.8038 23.0281 11.3775 -6.29424 6.84391 -3985 4 12.7596 29.6284 22.9364 3.04418 8.52871 -1.54448 -3986 4 11.6562 28.9633 23.7417 -11.9653 1.92572 -6.97409 -3987 6 13.0879 10.2853 41.0171 -47.2786 6.02767 7.69694 -3988 4 13.8008 10.0588 41.5617 38.8858 -12.6991 24.323 -3989 4 13.445 10.533 40.1929 12.5253 9.31307 -31.237 -3990 6 45.8279 29.9763 22.3517 -19.0059 -47.3471 -0.794771 -3991 4 46.3385 30.6632 22.7121 22.9496 35.5749 11.5915 -3992 4 46.1736 29.1608 22.8005 -10.4716 15.4455 -15.9284 -3993 6 41.5587 12.1258 14.79 16.8952 2.46742 -19.497 -3994 4 40.8127 12.0778 15.3866 -8.88903 2.06539 11.4921 -3995 4 41.9001 13.025 14.8368 0.886253 5.83282 4.44761 -3996 6 18.1774 7.21532 24.17 -10.7079 71.0597 15.5191 -3997 4 17.3895 7.85304 24.2309 32.278 -29.8877 -8.26822 -3998 4 17.8432 6.3671 24.0218 -31.5603 -50.1252 -1.23769 -3999 6 1.46617 28.3087 7.5822 17.4051 32.8243 -18.4272 -4000 4 0.972435 27.5241 7.77639 -23.983 -7.56132 -3.64975 -4001 4 0.919057 29.0368 7.16413 8.17263 -22.6878 11.3207 -4002 6 11.3257 12.3178 24.0505 6.50608 36.5044 21.7543 -4003 4 11.787 12.9182 24.6663 -15.142 9.53056 -9.69028 -4004 4 11.7144 11.5384 24.3755 9.90684 -45.3393 2.97811 -4005 6 17.9727 40.4585 24.4268 -2.1753 13.4943 43.6914 -4006 4 18.2079 40.9973 23.706 15.3173 17.1897 -35.5256 -4007 4 17.8423 41.1404 25.131 2.16294 -27.9915 -10.5346 -4008 6 25.5983 7.44259 34.0136 19.3716 5.77393 -21.6373 -4009 4 25.8935 7.97324 33.2232 -7.88236 -13.8451 20.6491 -4010 4 24.6626 7.5793 34.1612 -12.3217 5.75259 0.6842 -4011 6 16.9533 36.3934 7.79695 -14.7733 -58.972 -15.2131 -4012 4 16.1509 35.7821 7.92089 32.5681 38.8119 0.0631702 -4013 4 16.873 37.2333 8.21975 -10.866 19.0251 14.3825 -4014 6 12.4478 39.1676 36.8063 -58.2746 -19.2691 -7.14825 -4015 4 13.2621 39.5728 37.0444 24.763 -2.90148 -1.94315 -4016 4 12.5678 38.2718 36.42 14.2903 21.5885 11.3364 -4017 6 23.4428 1.91286 37.7232 -9.22102 6.32267 -24.8838 -4018 4 22.7837 1.60923 37.0782 3.11058 2.78987 13.6287 -4019 4 23.6923 2.7833 37.361 6.97145 -2.92816 9.87668 -4020 6 26.6131 34.8527 39.0629 -0.358317 22.46 -5.08852 -4021 4 25.9211 35.0251 39.7209 4.63868 -0.642547 -8.45736 -4022 4 26.6245 35.623 38.4346 -11.8568 -25.3624 13.8384 -4023 6 44.7506 35.5772 23.1679 10.7298 -18.8811 -26.4233 -4024 4 44.6498 36.2622 23.8111 -7.39072 22.4611 10.5052 -4025 4 44.899 35.9413 22.2637 -2.27133 -5.1907 16.9936 -4026 6 34.6136 35.4178 26.71 -15.9342 1.46423 13.2724 -4027 4 33.7739 35.201 27.1682 15.3038 9.13482 -13.5788 -4028 4 35.2424 35.4667 27.4557 -1.55634 5.60609 -12.3698 -4029 6 12.4253 29.8367 9.37257 6.8074 7.71813 14.8361 -4030 4 12.5954 30.1793 10.279 -1.64518 -2.79843 -17.3301 -4031 4 11.9756 30.5342 8.87466 -2.55144 0.413422 5.70549 -4032 6 46.4578 41.3781 16.9525 -1.71223 -15.9012 -6.63524 -4033 4 46.309 0.164546 17.5847 2.66821 13.6546 8.2853 -4034 4 46.3887 41.8168 16.0911 -0.805017 -2.71613 2.08401 -4035 6 39.1753 31.0467 24.0118 -3.10819 6.08124 -21.6124 -4036 4 39.1065 31.2708 23.0301 -7.23524 -5.82233 36.9271 -4037 4 38.2867 31.0608 24.4123 9.52041 3.88051 -10.8568 -4038 6 40.5402 9.7597 28.9847 14.8037 -28.2595 -25.194 -4039 4 40.7176 8.78836 28.9335 -4.00485 22.4893 3.39032 -4040 4 39.9733 9.89103 29.7293 -9.65138 5.58475 19.0645 -4041 6 33.5593 11.9211 22.729 -1.15717 -3.69298 36.7387 -4042 4 33.4631 12.1387 21.8005 -14.8881 8.7456 -3.74916 -4043 4 32.9393 12.4796 23.2922 26.8098 -15.4098 -27.756 -4044 6 29.0159 38.7519 2.46278 27.6721 -15.5988 -40.3681 -4045 4 29.1586 39.6546 2.1748 2.74048 3.67355 2.54153 -4046 4 28.5501 38.8453 3.26351 -22.211 -0.421087 25.3577 -4047 6 51.2833 6.14739 28.3043 6.24107 -1.78447 -16.8419 -4048 4 51.6927 5.30788 28.0231 -4.79213 3.01935 13.8596 -4049 4 51.5671 6.73798 27.5888 -1.89698 -2.53529 10.4249 -4050 6 34.1064 16.6123 14.042 -37.0155 -16.4066 -7.07731 -4051 4 33.9904 17.5439 13.9588 -10.6946 23.5239 -0.125603 -4052 4 35.0244 16.4872 14.0391 48.662 -2.86898 -0.118382 -4053 6 34.4321 40.0645 7.48859 13.9518 5.57425 38.6209 -4054 4 34.6497 40.8416 6.93548 -15.3832 -25.9537 -5.407 -4055 4 34.0868 39.3056 7.01264 2.49953 7.17747 -18.8692 -4056 6 42.5297 22.9808 4.38266 2.56422 12.7755 -29.8183 -4057 4 42.7079 23.1404 3.43503 2.07895 -8.20356 9.72626 -4058 4 41.6007 23.2438 4.43282 3.68115 -1.88729 13.9368 -4059 6 1.41725 11.7089 10.583 40.9585 72.4956 7.82458 -4060 4 2.29602 11.7947 10.1149 -31.3121 -19.1762 2.07637 -4061 4 1.32217 12.6809 10.8959 0.250133 -47.8987 -12.0904 -4062 6 10.0222 17.1523 40.4009 -13.9984 -42.4532 23.0969 -4063 4 9.09922 16.7881 40.4362 25.3227 17.9847 -3.64852 -4064 4 10.5566 16.4623 40.9043 -11.7978 28.1532 -20.1855 -4065 6 26.3773 1.16785 23.7951 0.897687 17.1036 -20.4546 -4066 4 26.2949 1.59753 22.8926 6.72339 -10.2637 31.134 -4067 4 26.8106 1.83522 24.3632 0.404944 -5.36666 -8.232 -4068 6 4.47728 16.2319 39.0174 38.9165 -19.7518 -18.3291 -4069 4 4.60126 15.8787 38.0926 -3.95383 11.2541 23.7603 -4070 4 5.37849 16.1152 39.4714 -36.6531 9.54225 -13.0705 -4071 6 24.3645 39.8454 14.0862 11.6717 18.512 -7.42816 -4072 4 24.2179 40.7168 13.6655 -1.51261 -13.0973 5.973 -4073 4 25.144 39.5095 13.6466 2.38152 -7.3908 -1.6645 -4074 6 19.9724 19.004 10.1294 8.87966 -14.5095 2.71373 -4075 4 19.0999 19.3915 10.2782 -1.93643 -3.06257 7.63815 -4076 4 20.1403 18.2899 10.8137 -9.49435 28.7308 -18.8504 -4077 6 45.2455 15.0555 25.2985 9.44949 25.5865 29.6023 -4078 4 44.5225 15.6147 25.6238 -9.11717 -2.3226 -13.4673 -4079 4 44.9162 14.4027 24.6993 -17.0358 -18.2103 -14.0354 -4080 6 47.6513 32.9537 29.9733 -3.02769 -8.48031 15.1317 -4081 4 47.7848 32.4488 30.7976 5.01558 10.2706 -8.76515 -4082 4 46.6987 33.0693 29.9097 -5.02316 -0.316015 -4.02449 -4083 6 9.31033 14.1561 35.6305 -9.15199 13.4931 14.7277 -4084 4 10.2186 13.9515 35.3646 1.69372 -1.68405 10.862 -4085 4 9.25805 14.5533 36.5394 11.2175 -11.577 -22.5615 -4086 6 0.560208 28.7354 32.128 -23.2584 38.0618 20.8665 -4087 4 0.439761 29.1616 31.2639 2.79308 -8.58991 0.800302 -4088 4 0.67028 27.8063 31.9961 10.5465 -16.7679 -9.91325 -4089 6 26.1282 14.1993 40.8411 59.6454 -38.6249 5.43898 -4090 4 26.432 13.4524 41.4491 -20.3805 31.5142 -12.0858 -4091 4 25.201 14.2926 40.8644 -35.6636 2.31432 7.08225 -4092 6 38.0409 1.72795 37.3461 -15.986 9.3487 3.27435 -4093 4 38.337 1.77003 36.4219 -6.4212 0.733726 8.60438 -4094 4 37.1869 2.24333 37.3721 25.3175 -16.9011 -0.126137 -4095 6 43.391 21.0055 0.385428 11.1435 51.3868 10.1231 -4096 4 43.3728 21.9356 0.739051 -22.7765 -27.5137 5.23027 -4097 4 44.2566 21.1078 41.893 4.66373 -25.0138 -11.6612 -4098 6 29.7339 12.3948 17.084 15.7249 11.0657 13.1734 -4099 4 30.3928 12.9555 17.5239 -4.04604 16.1495 -27.1654 -4100 4 29.6387 11.801 17.8166 -19.321 -23.8097 4.84602 -4101 6 21.0831 10.9976 35.6454 20.8751 25.9078 26.8503 -4102 4 20.9144 11.9356 35.5 -2.5465 -0.914036 2.40284 -4103 4 20.6111 10.5739 34.9651 -17.7649 -25.2648 -31.6786 -4104 6 24.3635 22.1336 17.0651 -49.7832 5.03398 -16.9936 -4105 4 24.7447 22.8357 16.5516 14.0354 11.6369 -2.31656 -4106 4 25.0369 21.6158 17.4366 35.7007 -17.2122 18.4164 -4107 6 44.2543 9.63808 6.15039 20.313 -11.2139 14.5913 -4108 4 44.7688 9.46356 5.36091 -1.47318 -0.699349 -10.0319 -4109 4 43.371 9.9028 5.92157 -14.9065 6.10764 -5.2575 -4110 6 40.8032 2.87739 6.28666 -13.1289 22.479 10.901 -4111 4 40.3272 3.11809 7.09229 2.74106 -9.45257 -1.64817 -4112 4 40.5645 3.60702 5.69531 8.12536 -6.41414 -12.3146 -4113 6 23.4888 29.7691 25.1996 -20.8577 -7.3866 7.78845 -4114 4 23.0356 30.0691 24.4173 -11.1707 -5.96106 -7.76576 -4115 4 24.1981 30.3761 25.2406 38.2449 14.7306 0.541559 -4116 6 45.2336 20.6129 7.48752 -14.5833 -17.9538 -3.88696 -4117 4 44.4222 20.5961 6.94177 10.1673 3.83834 -0.615812 -4118 4 45.4226 19.6724 7.65027 4.1577 11.2609 0.378107 -4119 6 44.1804 26.5848 16.646 -7.77871 8.0927 60.0057 -4120 4 44.4497 26.5291 15.7549 9.82788 -17.3929 -39.3829 -4121 4 43.995 25.6977 17.0036 0.668911 -2.30329 -14.751 -4122 6 23.5902 27.0659 18.0913 -39.7013 -11.93 7.95298 -4123 4 23.083 26.2674 17.8176 19.208 11.4009 -9.44785 -4124 4 22.9184 27.4761 18.6801 25.6051 0.00742342 -8.40738 -4125 6 45.1467 16.0991 8.91755 -25.3782 -1.90264 -8.59791 -4126 4 44.1891 15.9425 8.7462 16.1978 6.4454 1.17339 -4127 4 45.2138 16.0078 9.87006 7.52298 -2.6657 10.2407 -4128 6 39.0203 15.1531 5.23259 28.6956 12.0263 -26.8074 -4129 4 39.7994 15.5772 4.7964 -10.087 -12.1112 6.39319 -4130 4 38.3368 15.7917 5.08662 -19.5574 10.6606 0.980846 -4131 6 40.468 4.77411 20.0927 -27.3359 -4.798 12.1592 -4132 4 41.2634 4.72652 19.6 29.6653 -1.38796 -18.2664 -4133 4 40.7147 5.23292 20.8909 -0.487482 4.30709 11.6637 -4134 6 35.8395 28.4372 39.9091 -50.8572 -25.335 -8.14583 -4135 4 35.0416 27.8127 39.7761 37.8149 25.8469 12.2999 -4136 4 36.4241 28.1912 39.1903 12.774 -11.5781 0.139918 -4137 6 26.5706 3.57143 2.67715 -46.9093 11.529 -12.2012 -4138 4 26.01 3.47498 1.86726 21.0232 -0.263485 19.1529 -4139 4 25.9795 4.13239 3.25499 25.5536 -16.3527 -3.3314 -4140 6 2.96374 21.6426 17.6806 -14.2306 -5.51577 -4.68338 -4141 4 2.93927 22.2072 18.4518 0.989431 6.72084 9.51867 -4142 4 3.70489 21.9005 17.1296 5.59779 10.8847 0.849605 -4143 6 12.8869 25.0552 25.9401 15.4127 26.4598 -14.83 -4144 4 13.2774 25.9118 25.6194 -5.06291 -21.1213 8.866 -4145 4 12.0842 24.9634 25.4247 -11.7493 -3.09829 -2.0396 -4146 6 41.5869 20.6707 14.1801 -22.4147 -6.05744 0.611169 -4147 4 42.2929 20.1295 13.8255 12.8925 2.43785 -7.39699 -4148 4 41.9118 21.5622 14.3536 8.70683 -8.7017 2.36606 -4149 6 1.26372 39.5934 11.5416 -2.31472 -23.2994 -17.666 -4150 4 1.60499 38.7626 11.0579 -12.721 36.8399 30.164 -4151 4 1.30151 39.4907 12.5143 8.15813 -4.07121 -11.1907 -4152 6 16.0274 39.0089 34.0759 -23.376 3.35378 -54.2756 -4153 4 15.5279 38.2654 33.6809 12.2329 5.59336 21.1278 -4154 4 15.9645 39.6681 33.3256 8.94624 -4.65522 31.8649 -4155 6 20.5749 7.01511 25.5545 -9.93748 22.9073 -1.77669 -4156 4 20.7998 7.9126 25.2373 7.69672 -13.5438 0.480138 -4157 4 19.6147 7.02086 25.4453 1.79337 -5.45304 -5.32881 -4158 6 45.1903 25.5946 39.1745 -26.3826 2.10768 23.1727 -4159 4 45.9078 26.0337 38.7511 23.0136 15.7961 -19.2282 -4160 4 45.315 24.6755 38.9972 4.74877 -22.0383 -3.82349 -4161 6 19.9254 40.1108 28.2935 0.936604 13.13 -6.83142 -4162 4 19.0415 40.3022 27.9603 -1.00367 -13.9734 -0.221352 -4163 4 20.1058 40.9072 28.8104 6.81084 -8.28794 7.10232 -4164 6 26.5025 14.2024 27.3816 7.55525 -11.5245 -39.7478 -4165 4 25.5661 14.1885 27.2241 -23.3405 -0.187867 -1.3667 -4166 4 26.5864 14.6167 28.2174 4.05242 7.69107 36.9512 -4167 6 51.349 25.9455 3.44193 13.1564 1.83251 -14.1309 -4168 4 51.0731 25.276 4.04973 -8.84751 -13.2679 15.0063 -4169 4 51.8098 25.4164 2.75525 -2.9574 19.5765 2.79729 -4170 6 20.1579 26.1269 2.66057 8.08543 -14.232 12.5138 -4171 4 20.4198 25.2285 2.95049 1.99012 13.1431 -7.88687 -4172 4 19.9848 26.1042 1.70984 -1.68704 0.137755 2.48294 -4173 6 3.12857 11.9594 27.2244 18.8731 20.7243 14.7894 -4174 4 2.60719 12.6622 26.8077 5.30838 -2.59233 -3.81502 -4175 4 3.76928 12.4285 27.8301 -19.9135 -11.7573 -12.7739 -4176 6 30.1745 26.3671 4.00755 44.117 -33.7612 35.926 -4177 4 30.7719 25.91 3.40695 8.20711 -11.5121 5.52432 -4178 4 29.6741 26.8182 3.4039 -49.0538 48.0497 -39.0484 -4179 6 19.309 20.6617 30.5327 -6.17305 20.3286 19.7257 -4180 4 19.3357 21.5037 31.0044 -16.2324 -1.53368 2.5841 -4181 4 20.215 20.6027 30.2783 24.1248 -10.9268 -16.9107 -4182 6 13.5428 36.2605 0.333332 15.0011 -10.6689 28.2547 -4183 4 13.9636 37.1467 0.274336 -13.564 -9.3403 -16.0521 -4184 4 12.8146 36.0991 41.6409 -4.77188 14.7057 -15.3617 -4185 6 13.69 21.7667 35.9665 -20.2473 -15.4187 -13.4538 -4186 4 13.4364 21.3658 35.099 7.7487 10.4825 13.8843 -4187 4 14.5406 22.1631 35.8296 17.4857 6.37333 -3.13554 -4188 6 39.4374 1.76506 25.3393 -36.4427 -7.29022 -10.5984 -4189 4 39.9364 2.34528 25.9215 16.7605 -3.08023 1.72977 -4190 4 39.8192 0.8892 25.1573 19.013 15.1682 11.727 -4191 6 18.3049 6.14326 35.8392 -10.8025 -19.5812 3.54688 -4192 4 18.125 5.32611 36.3393 4.50778 0.182671 -16.8727 -4193 4 18.2664 6.78418 36.55 10.3297 13.4079 -7.40032 -4194 6 2.50698 24.635 10.1008 2.82606 57.1639 14.1456 -4195 4 3.34783 24.2504 10.0645 38.9609 -42.7111 -6.9151 -4196 4 2.85647 25.509 10.4424 -34.1939 -15.4438 -5.60802 -4197 6 35.8245 9.94707 1.36321 12.392 22.5458 6.51215 -4198 4 36.2598 10.3662 0.602857 -1.03193 -1.33218 7.37913 -4199 4 36.14 10.4815 2.15194 -8.91958 -29.9524 -28.0328 -4200 6 29.0093 17.9332 41.5934 -7.9582 -11.0366 0.585828 -4201 4 28.5465 17.2289 41.1281 -16.7755 -3.81322 9.83818 -4202 4 29.6221 18.1453 40.9114 24.9254 25.1746 -10.164 -4203 6 46.0106 27.0842 25.8657 -15.8538 -10.6571 1.20957 -4204 4 46.7573 26.8966 26.4316 13.3887 1.52966 8.34957 -4205 4 45.3967 26.3449 26.0537 1.02353 6.85943 -7.5889 -4206 6 28.1115 10.6516 35.9124 -31.4415 -9.81676 -35.067 -4207 4 27.3321 11.0804 35.4953 10.9044 -14.8673 0.927998 -4208 4 28.4149 11.3158 36.4913 19.5717 24.3857 28.0975 -4209 6 25.9462 20.1874 24.7713 21.0981 19.7274 8.06252 -4210 4 26.7479 20.7296 24.6265 -12.3387 -9.71047 -3.27099 -4211 4 25.8934 20.1715 25.7373 -11.4252 -1.9185 3.65337 -4212 6 32.2315 30.2636 10.2038 46.2181 -42.2335 3.06511 -4213 4 32.6954 30.7903 9.55855 -13.4496 21.2522 -10.6663 -4214 4 32.9512 29.5744 10.3289 -28.7668 14.232 9.31608 -4215 6 5.05112 34.4033 23.8133 19.5013 -14.7597 17.0713 -4216 4 5.8904 34.9145 23.8209 -18.4686 -4.57798 -7.44977 -4217 4 4.4328 34.8283 23.2333 -4.78059 12.4432 -11.9709 -4218 6 29.6287 34.9421 23.1129 15.2461 20.4143 1.29823 -4219 4 30.2662 35.203 23.7945 -9.70178 1.77141 2.28452 -4220 4 29.7307 34.0083 23.0447 -4.13429 -24.1479 2.03513 -4221 6 52.1909 25.2296 36.2512 2.86438 -10.6824 22.6831 -4222 4 51.9483 25.3775 37.2028 5.23419 -4.07811 -26.4725 -4223 4 52.3343 24.2634 36.1804 -4.32722 6.81431 1.64545 -4224 6 6.96184 41.26 14.9825 2.80521 -5.8094 -40.534 -4225 4 7.04984 41.0874 15.8994 5.94782 -9.0625 22.8431 -4226 4 7.58542 40.6644 14.4953 -8.6815 16.2518 18.3581 -4227 6 27.6618 39.1341 4.65497 -15.321 -2.42325 19.5764 -4228 4 26.8583 38.6531 4.9607 13.8024 7.31782 -7.34321 -4229 4 28.2878 39.16 5.39008 -5.06496 -7.53921 2.22048 -4230 6 44.4448 15.8874 30.3939 -2.31018 0.103575 -22.4191 -4231 4 43.6353 16.4379 30.2788 15.6665 -12.4266 1.42045 -4232 4 44.7559 15.574 29.5018 -16.8402 11.4423 19.721 -4233 6 27.2939 38.1254 13.0955 15.3768 -40.6351 2.35664 -4234 4 27.6299 37.3572 12.5713 -6.06373 15.2601 5.99839 -4235 4 27.2975 37.7701 14.0147 -10.0522 11.5876 -10.9657 -4236 6 26.6773 32.9794 36.8294 -32.6396 -25.4624 12.1292 -4237 4 27.3491 33.5429 36.5103 30.2383 22.5556 -9.12925 -4238 4 26.1784 33.4868 37.4729 2.39424 7.35453 7.52648 -4239 6 26.3034 28.2003 31.7109 71.1077 16.3155 0.283388 -4240 4 26.8193 28.3341 30.863 -27.929 -6.55919 23.3278 -4241 4 26.9955 28.4613 32.4053 -35.143 -9.24619 -18.2719 -4242 6 49.2075 35.7729 23.3324 -21.4287 30.6035 9.89313 -4243 4 49.7648 36.3085 23.9054 5.92838 -6.84736 -0.0129328 -4244 4 49.7125 35.0813 22.9401 23.5965 -22.3057 -11.2126 -4245 6 44.2384 15.3735 33.5479 -0.546939 -12.4927 -0.897907 -4246 4 44.8734 15.133 32.8785 13.8917 -2.34347 -2.72297 -4247 4 43.5631 15.8174 33.0372 -7.79828 14.1806 -0.143619 -4248 6 16.6415 35.2629 14.0425 -13.711 -12.7272 -22.5016 -4249 4 16.8779 36.1297 14.3524 2.35153 17.3801 14.4176 -4250 4 15.7232 35.3535 13.695 18.4875 1.24889 7.88518 -4251 6 45.2979 21.4768 12.0753 -61.6802 -17.7786 9.36854 -4252 4 45.9745 21.1118 11.5746 47.2025 -15.5682 -31.9287 -4253 4 44.6407 20.7302 12.0307 13.4445 30.1014 15.4365 -4254 6 51.647 5.33893 20.0992 17.3373 6.85256 40.4731 -4255 4 51.8423 5.82757 20.9547 -12.0569 -16.4938 -26.4666 -4256 4 50.8652 5.75336 19.736 -8.70547 10.2387 -6.49138 -4257 6 22.616 27.3068 0.953729 -12.5585 5.72419 11.7926 -4258 4 21.9912 27.9206 1.39427 2.62886 -13.0847 -9.82719 -4259 4 22.9744 27.8285 0.229956 6.91293 3.08187 -2.36887 -4260 6 46.8924 12.1405 22.3241 28.0037 10.4006 6.07885 -4261 4 46.5361 12.6234 21.5839 -13.5229 3.11861 -11.9828 -4262 4 46.2058 11.655 22.757 -25.8682 -9.85748 8.02404 -4263 6 33.7577 5.61095 25.2306 8.81298 -10.6825 9.18366 -4264 4 34.4045 5.06092 24.7535 -5.77276 6.31779 -0.0821136 -4265 4 33.06 5.8369 24.6155 -4.37455 2.20678 -7.03208 -4266 6 44.2424 18.1337 27.2287 35.5912 4.17402 -1.61274 -4267 4 44.1428 18.6708 26.4104 -1.15401 -3.8952 20.8354 -4268 4 45.2041 18.2132 27.495 -32.4507 -0.562547 -10.2772 -4269 6 5.27745 36.9951 29.0779 -48.9341 45.2857 -18.2185 -4270 4 4.83797 37.847 28.7 19.7525 -41.2711 21.6555 -4271 4 6.18662 37.2124 29.1987 31.023 4.60304 7.81739 -4272 6 20.0415 5.02171 38.9415 13.5567 -45.1901 -20.6947 -4273 4 19.673 5.46942 39.6755 -5.65499 20.9205 26.8401 -4274 4 20.3443 4.13258 39.2728 -11.021 23.424 -4.53385 -4275 6 17.9077 2.77821 33.872 -28.7289 7.66476 22.1934 -4276 4 18.5675 3.36618 33.4993 11.2764 5.36232 -3.32863 -4277 4 17.289 3.30252 34.4687 25.3234 -20.0176 -17.8345 -4278 6 5.56252 23.3664 22.3199 23.4646 34.0494 22.6536 -4279 4 6.31266 23.4141 21.6995 -10.6272 -11.1368 -5.13028 -4280 4 5.83055 24.0852 22.9498 -18.4748 -15.0058 -11.9197 -4281 6 12.7366 28.0136 40.0786 16.9267 17.0007 -14.1953 -4282 4 12.7736 28.981 40.2539 2.04889 -13.1204 -10.7842 -4283 4 13.1752 27.8683 39.2015 -12.0592 5.90979 20.7524 -4284 6 50.5208 38.8121 28.4283 -2.96204 -29.3557 2.62021 -4285 4 51.1161 39.4306 28.008 -0.383593 20.3423 -2.32338 -4286 4 49.7133 39.2143 28.7877 7.69194 10.1621 -6.76025 -4287 6 33.551 8.21903 17.8634 -36.1599 -47.4859 45.2019 -4288 4 33.9333 8.85376 17.3385 32.2471 57.3944 -47.1321 -4289 4 33.8604 7.38657 17.5128 5.83122 -9.97324 -0.737685 -4290 6 34.648 34.7105 17.7828 9.01761 -19.7832 -8.77749 -4291 4 35.1788 35.3328 18.2888 -3.00831 8.66808 4.62333 -4292 4 35.2883 34.0014 17.5711 -12.5093 2.94991 -0.39307 -4293 6 40.7261 5.27864 23.3991 8.21105 0.19251 11.4926 -4294 4 41.4259 4.93717 23.9966 -11.2767 2.88733 -17.4667 -4295 4 40.0598 4.58084 23.2941 1.87831 5.06613 5.43463 -4296 6 16.9137 27.769 14.4809 73.6258 -34.7175 -8.82476 -4297 4 16.0667 28.1115 14.4612 -62.8462 32.6704 -2.60496 -4298 4 17.5486 28.5101 14.4313 -15.9271 -1.25076 7.8547 -4299 6 29.0219 14.6595 5.00786 20.8741 -13.5443 13.1138 -4300 4 29.536 13.8229 4.89138 -12.0375 16.0826 3.98067 -4301 4 28.8859 14.7576 5.97494 -2.91261 0.0620574 -16.4413 -4302 6 36.854 17.7325 5.08016 4.48522 -18.3735 -43.8449 -4303 4 36.2168 18.3553 5.39001 -11.7806 18.6728 17.0618 -4304 4 36.8305 17.8608 4.09391 11.7548 -5.76061 25.8999 -4305 6 27.7142 25.5094 34.8662 20.7401 -29.3529 -12.6468 -4306 4 28.3997 25.1535 35.4786 -13.7878 13.2187 -9.69645 -4307 4 27.3728 26.292 35.2699 -5.77421 14.8272 18.3022 -4308 6 24.7481 17.2805 18.0642 -3.31447 -10.4308 -2.46491 -4309 4 25.3087 17.9154 18.5049 2.27957 10.048 8.00722 -4310 4 24.0564 17.0505 18.7104 4.01172 4.3516 -6.8818 -4311 6 30.1789 1.58441 5.83411 4.12275 19.8646 -71.4749 -4312 4 29.4821 1.85802 6.42075 -6.9839 1.28517 8.89789 -4313 4 29.959 2.0434 4.91278 6.77151 -29.6581 61.3265 -4314 6 37.452 25.891 8.43789 -40.1641 -31.4732 50.6902 -4315 4 38.334 25.9927 8.78667 20.6785 -4.95116 -4.15592 -4316 4 36.9881 25.2791 9.14634 19.6253 32.8331 -49.0064 -4317 6 24.7604 7.00734 2.27008 32.0581 9.85747 -12.4546 -4318 4 25.4028 6.31463 2.48931 -5.40489 7.62931 7.6933 -4319 4 23.9158 6.58667 2.26874 -21.5893 -3.78057 4.11792 -4320 6 25.7887 38.8506 10.7619 -30.5475 28.1992 -59.3139 -4321 4 26.3103 38.4194 11.381 38.5207 -12.4255 48.7922 -4322 4 26.1525 39.7259 10.4932 -1.18865 -9.03037 15.3914 -4323 6 0.555207 13.578 28.1388 12.6332 42.7054 11.738 -4324 4 0.341766 12.7807 27.7179 -10.1825 -36.9478 -16.4943 -4325 4 0.413626 13.4435 29.0864 -5.17296 -1.28815 -2.85065 -4326 6 20.4105 17.1191 12.037 -17.9302 -38.4569 -26.5492 -4327 4 20.2295 17.2547 12.9605 -1.34068 5.07474 20.9983 -4328 4 19.8884 16.3005 11.7926 16.4515 20.0565 4.33162 -4329 6 30.9925 7.37797 16.6653 29.7996 22.3073 3.61878 -4330 4 31.2643 7.03844 15.7784 -2.63758 10.9944 17.123 -4331 4 31.7569 7.94595 17.0261 -27.6116 -29.8279 -14.8225 -4332 6 10.2093 5.78517 12.1714 32.5037 6.96704 58.397 -4333 4 10.1014 6.35617 11.4591 -8.08786 32.1119 -50.7901 -4334 4 9.65707 5.06197 12.024 -36.7963 -41.1043 -15.4671 -4335 6 18.4347 31.3493 24.155 3.48135 -6.25246 2.65688 -4336 4 18.4439 30.3878 24.2879 -2.95335 1.71216 0.944019 -4337 4 18.3198 31.7316 25.0273 -3.67252 2.09543 1.27238 -4338 6 27.8948 29.2525 29.2666 2.33504 21.8021 -21.5937 -4339 4 28.3627 29.5914 28.4251 -11.9103 -18.4763 37.4515 -4340 4 28.5196 28.9609 29.9463 14.9294 0.890267 -8.6061 -4341 6 38.3738 15.4456 29.791 12.9945 -28.6313 15.0543 -4342 4 38.0891 14.5036 30.0544 22.1369 39.5396 -7.74746 -4343 4 39.2957 15.632 30.1541 -37.4531 -3.97597 -10.3113 -4344 6 21.7041 34.7992 5.56934 -10.1436 -56.1371 25.2208 -4345 4 21.4621 33.8673 5.89439 16.7439 32.0975 -19.9868 -4346 4 20.9431 35.2741 5.907 -2.46203 13.3807 -4.97838 -4347 6 18.2064 16.8274 1.01093 1.02147 5.09087 9.91972 -4348 4 17.6405 17.264 0.353478 -0.489627 -6.58546 6.49815 -4349 4 17.8529 17.0628 1.89865 0.517006 0.361128 -13.8735 -4350 6 43.5166 18.4972 39.3436 16.5286 13.9247 -42.0759 -4351 4 43.0101 19.1966 39.7112 -21.9319 15.1254 24.622 -4352 4 43.7095 18.933 38.4597 1.00685 -29.3013 20.2287 -4353 6 17.7976 10.0688 35.5434 7.86102 19.599 -20.2005 -4354 4 17.8945 9.40709 36.2105 4.74187 -18.2058 11.3424 -4355 4 18.5459 9.97323 34.9151 -16.2901 -5.18221 9.2364 -4356 6 36.5889 30.5599 29.0828 -33.0481 48.6405 -12.465 -4357 4 36.5132 31.4977 28.7143 1.54088 -37.0728 8.50934 -4358 4 37.4982 30.324 28.9756 25.7485 -11.7594 -3.68806 -4359 6 38.4943 35.9682 10.4222 10.3079 16.2999 40.226 -4360 4 38.6552 36.6966 11.1228 -3.33458 -34.9071 -25.8136 -4361 4 38.3509 35.1294 10.9235 4.16648 17.1849 -3.98913 -4362 6 43.4036 18.8037 34.3607 -18.7725 -42.8138 41.3108 -4363 4 42.9709 18.1893 33.7432 11.3097 10.906 -2.86187 -4364 4 43.2777 18.3171 35.2411 6.94038 29.5352 -30.5758 -4365 6 11.0585 40.2128 6.10885 -15.7783 5.94868 1.16987 -4366 4 11.5965 40.9262 6.45194 10.3679 4.26541 4.32644 -4367 4 10.1443 40.5526 6.13585 6.40705 -5.05479 -5.29954 -4368 6 48.3342 13.7493 24.4707 -3.46168 30.4962 28.8754 -4369 4 47.8576 13.3588 23.754 -13.8134 -6.92474 -20.9085 -4370 4 47.8711 14.5963 24.7134 14.7345 -25.1065 -10.1999 -4371 6 1.47205 25.7712 23.7829 0.184952 23.7651 -2.41746 -4372 4 0.854396 26.4618 23.4919 -3.79407 -11.1699 -2.17794 -4373 4 2.13056 26.3319 24.2122 9.67536 -12.9921 7.11562 -4374 6 20.5856 0.045789 21.1048 4.96875 -22.7073 -7.43464 -4375 4 19.8117 0.249922 21.5931 -19.4423 21.7426 16.1957 -4376 4 20.4519 41.001 21.0443 13.8042 -0.350206 -3.82588 -4377 6 37.6675 12.896 30.7055 18.9575 -14.1068 -43.1025 -4378 4 37.1872 12.5493 29.907 3.14127 2.53034 24.3729 -4379 4 37.0391 13.1763 31.3358 -31.377 6.23238 20.3235 -4380 6 49.4665 17.3801 9.24655 -8.32961 25.946 -15.5009 -4381 4 48.5345 17.665 9.32633 16.3924 -11.5392 1.15372 -4382 4 49.8219 17.9883 8.54454 -1.98957 -21.6031 19.5257 -4383 6 34.3643 5.3502 17.1421 32.952 7.78829 -18.2658 -4384 4 34.6245 5.26975 16.1857 -14.4704 2.64329 20.4158 -4385 4 33.4298 5.20109 17.2262 -20.6176 -11.2241 -0.901893 -4386 6 14.7832 27.6655 0.085624 -10.3553 13.8949 -22.792 -4387 4 14.1034 27.8892 41.3249 2.03342 -11.2849 14.5146 -4388 4 15.1757 28.5319 0.287496 2.39463 -6.00136 9.68974 -4389 6 48.8635 15.5211 20.7504 -7.30397 3.37214 15.1279 -4390 4 49.1252 16.3754 20.4371 0.183023 13.7927 -3.76167 -4391 4 49.1585 14.9241 20.0762 3.93917 -17.6947 -14.7742 -4392 6 23.8074 40.3851 20.3877 -2.3041 21.5375 32.1864 -4393 4 23.5266 40.991 21.1382 8.45078 -18.9812 -28.3519 -4394 4 24.6929 40.0818 20.645 -4.8729 5.63426 -4.96266 -4395 6 35.18 31.4993 13.7142 -38.6695 32.0432 -41.3249 -4396 4 34.2219 31.3119 13.4889 30.0091 9.93153 3.95626 -4397 4 35.4367 30.7845 14.243 12.3636 -35.8089 30.5679 -4398 6 10.9775 9.01115 39.5206 -26.3812 35.8658 -19.2594 -4399 4 10.5557 9.91556 39.5205 15.5031 -28.3669 -8.85108 -4400 4 11.1542 8.87096 40.4393 5.31517 -3.54045 10.232 -4401 6 53.2061 4.88103 16.6049 -20.6689 -12.7794 3.6937 -4402 4 53.6782 5.3887 17.2239 33.7717 25.1716 19.5104 -4403 4 52.5676 4.51498 17.2255 -11.3933 -13.1169 -19.2452 -4404 6 7.83562 33.8039 26.1496 42.0062 50.3869 -17.047 -4405 4 7.62463 34.1533 27.0155 -6.33847 -9.39794 9.82588 -4406 4 8.42034 34.5749 25.7852 -30.6961 -50.8642 6.91563 -4407 6 31.3279 27.9472 6.28298 4.37835 -19.3247 -9.6219 -4408 4 31.922 27.5111 6.93657 -10.4846 5.09347 -11.9486 -4409 4 31.1129 27.3323 5.53276 6.79934 9.76999 15.6259 -4410 6 31.3655 2.17383 41.055 18.9421 -1.98994 34.5993 -4411 4 31.8109 2.17902 0.04034 -17.0754 7.04602 -28.7946 -4412 4 31.2404 1.23747 40.9086 -7.00813 -7.80206 -8.22245 -4413 6 33.7652 4.25739 35.9001 -31.2863 -13.3655 20.8802 -4414 4 34.2485 3.80076 36.6104 5.56552 8.36292 -9.80816 -4415 4 32.8077 4.13792 36.1863 30.7439 3.51509 -16.9094 -4416 6 47.9725 16.0636 29.8584 -12.289 -4.0311 -5.35812 -4417 4 48.7208 16.4163 30.3732 -4.13056 -10.8519 0.408936 -4418 4 47.3533 15.5947 30.4559 16.7379 8.85318 -0.563064 -4419 6 49.3385 10.0935 28.5885 -11.8118 4.56009 -13.0989 -4420 4 48.5886 10.6638 28.8239 3.51911 -4.5157 1.44109 -4421 4 49.3924 10.1159 27.6088 6.69909 -1.91925 15.8757 -4422 6 21.4187 27.7693 29.76 2.80336 -20.4787 -6.37736 -4423 4 21.861 27.2354 30.4624 -7.84738 15.6574 -13.8161 -4424 4 21.1828 28.6282 30.0799 2.10219 20.3695 17.9057 -4425 6 11.6757 39.482 25.8517 13.5538 20.9417 -1.29545 -4426 4 12.2965 38.7786 26.0889 -7.12508 -2.9493 -2.05027 -4427 4 10.8193 39.0846 25.7116 -11.9056 -6.20494 0.0112269 -4428 6 22.9798 39.311 7.85817 -12.7601 -4.86939 -3.04246 -4429 4 22.3059 38.6219 7.95844 1.92638 3.98273 0.136758 -4430 4 22.5772 40.0658 8.31757 9.04497 -1.85468 3.82529 -4431 6 42.5415 35.9278 31.3391 13.0935 -70.9729 -20.1514 -4432 4 42.6447 35.4696 30.4714 -5.52665 5.17936 25.8951 -4433 4 42.5102 36.7973 31.0384 -8.93799 60.9387 2.27408 -4434 6 33.663 14.7412 3.98499 30.4225 -17.693 -39.6888 -4435 4 32.8564 15.2185 4.09596 -24.3526 16.5192 2.50389 -4436 4 33.8944 14.7916 3.00116 -11.9532 1.40502 32.6284 -4437 6 36.697 8.6017 17.5153 18.7294 -29.9333 -4.55465 -4438 4 37.1702 7.95911 16.9159 -11.687 24.5338 13.7544 -4439 4 36.2734 9.25409 16.9543 -7.54123 3.80926 -6.08989 -4440 6 20.8295 32.4146 17.3309 -48.7404 -21.5825 11.0081 -4441 4 20.1664 32.9726 16.9048 10.2664 9.72211 -3.82622 -4442 4 20.2271 31.8015 17.8465 35.2036 12.7196 -8.50107 -4443 6 20.7003 35.3218 14.1083 -3.44914 -18.0461 -19.2112 -4444 4 21.3182 35.5386 13.4099 3.08163 2.90557 -13.4495 -4445 4 20.919 35.9437 14.7754 1.56244 13.5022 22.2067 -4446 6 20.2323 2.51936 40.1651 -9.22326 -14.3688 36.1644 -4447 4 19.7926 2.34354 41.0434 13.5524 6.30823 -28.5037 -4448 4 20.7516 1.7186 40.0171 -1.27786 1.50094 -7.75906 -4449 6 15.0477 14.4672 0.24789 12.9865 -5.55034 -72.7807 -4450 4 15.4827 13.6954 41.6877 -12.87 20.0829 29.6139 -4451 4 15.2186 15.2036 41.5094 -2.93016 -13.2387 23.097 -4452 6 24.8149 37.3373 18.5213 2.43631 -2.68492 27.9859 -4453 4 24.4361 37.9203 17.8611 -0.249038 9.91659 1.71419 -4454 4 24.5604 37.6468 19.4234 0.486379 -6.00228 -23.279 -4455 6 3.16989 27.7944 5.24229 1.80682 -16.6913 61.515 -4456 4 2.664 27.92 6.09489 -0.254446 2.50987 -32.3978 -4457 4 4.0252 27.4816 5.63916 -14.135 1.37322 -28.2843 -4458 6 37.1257 39.0598 36.0573 4.58816 40.5807 23.3296 -4459 4 37.5599 39.5885 36.7783 -22.7086 -1.13864 -22.8071 -4460 4 37.5439 38.2379 36.1828 13.5973 -37.3165 -5.96047 -4461 6 41.3477 16.3672 3.84024 25.8131 6.72768 37.2631 -4462 4 41.4431 17.3182 3.89206 -17.3786 8.01961 -13.1803 -4463 4 42.0046 16.1549 4.54461 -14.0821 -19.2698 -21.0799 -4464 6 15.5755 3.1684 35.3585 1.47298 2.70845 -61.2084 -4465 4 15.1145 3.59171 34.5864 10.479 -16.2188 17.3147 -4466 4 15.2032 3.60881 36.0782 -15.9672 22.7619 40.5269 -4467 6 33.1731 24.2438 7.96729 6.41569 -10.7526 14.1331 -4468 4 33.3408 24.6773 7.1445 11.9115 -7.07525 -26.7187 -4469 4 32.5824 24.8707 8.33408 -19.4303 14.6961 21.7816 -4470 6 35.865 29.7374 15.5979 -29.8607 35.3275 -32.1308 -4471 4 36.7747 29.6672 15.7703 43.701 -12.5229 16.5971 -4472 4 35.3562 29.0371 15.9739 2.56537 -15.478 18.0667 -4473 6 17.5843 36.8354 41.8728 12.1708 -5.57123 -52.5088 -4474 4 18.1833 36.773 0.675699 12.2604 -1.93512 36.5948 -4475 4 18.2359 36.8623 41.125 -21.8566 7.06165 11.6698 -4476 6 26.5622 4.14672 31.1307 -32.6289 -51.1506 -31.7953 -4477 4 27.2582 4.59627 31.5457 41.9615 24.0313 17.3243 -4478 4 26.8928 3.23766 30.8727 -4.86114 29.783 15.5489 -4479 6 31.9552 1.33198 34.4369 -14.3248 -8.90334 35.5546 -4480 4 32.7269 1.15305 34.9944 8.32726 6.02564 -17.2377 -4481 4 31.2642 1.08685 35.0838 -0.545778 4.81468 -20.3916 -4482 6 24.491 14.7534 2.38457 33.2042 -23.9469 17.2683 -4483 4 24.2753 13.9637 2.92779 -7.56186 18.0622 -11.5291 -4484 4 25.4626 14.8414 2.55985 -20.2114 8.54272 -9.97318 -4485 6 25.7566 20.9055 27.5389 -1.15091 7.1508 6.95521 -4486 4 25.459 20.6057 28.4261 8.17968 -1.38894 -17.9407 -4487 4 25.6371 21.8685 27.5748 1.97223 -1.15564 -2.97875 -4488 6 18.1445 40.1527 30.6395 17.3729 -20.3781 15.2884 -4489 4 18.5141 39.2638 30.8544 -10.5973 16.1604 -9.36512 -4490 4 18.9393 40.7073 30.6583 -6.94059 7.54086 -5.9327 -4491 6 46.7889 23.8914 24.5979 7.31075 41.4222 -46.8858 -4492 4 46.2898 24.602 24.0741 10.6002 -32.8666 22.2289 -4493 4 47.4121 23.5287 23.9473 -6.99108 -0.957122 4.26591 -4494 6 45.6201 22.6921 26.5067 -14.1777 -10.0967 -12.8229 -4495 4 46.0372 22.9342 25.6668 -2.41585 -1.26552 16.8561 -4496 4 46.0784 23.1676 27.2003 -0.61408 1.28207 1.11474 -4497 6 20.1006 4.48803 26.6974 -40.8522 40.1383 42.8029 -4498 4 20.2489 5.43817 26.4853 8.37449 -26.4011 -0.951475 -4499 4 20.6602 3.93368 26.2205 34.0606 -24.4352 -38.1565 -4500 6 35.278 26.5864 12.552 0.280065 20.4825 10.9931 -4501 4 35.6728 25.7022 12.4634 2.08478 13.3641 8.87461 -4502 4 35.7774 27.1222 13.2104 -5.20465 -19.6779 -15.4464 -4503 6 3.25879 33.9669 12.2907 -5.01808 -25.4739 5.3677 -4504 4 2.34263 33.6224 12.3201 4.20809 12.7539 -0.381501 -4505 4 3.26735 34.9165 12.3326 -4.58918 17.9212 0.78916 -4506 6 36.6873 1.27899 25.5756 -31.8717 2.25298 32.7844 -4507 4 37.6116 1.37326 25.7779 18.4499 5.6721 -4.77344 -4508 4 36.2122 1.51788 26.4163 6.97172 -2.04149 -25.7728 -4509 6 16.8705 4.65685 24.0413 -35.5309 2.76318 -23.9776 -4510 4 15.8575 4.70434 23.9217 47.0687 -0.0954558 1.21401 -4511 4 17.247 4.33879 23.186 -5.50277 -2.28941 17.9023 -4512 6 39.6565 15.0715 7.80572 25.6093 19.6796 32.1194 -4513 4 39.2854 14.2576 8.13712 -9.42359 -13.1845 -9.18942 -4514 4 39.3628 15.2517 6.91527 -5.26665 -12.4192 -5.15573 -4515 6 9.97948 20.1659 2.91877 -9.38613 14.9664 11.2777 -4516 4 9.63877 20.6452 2.15027 4.12295 -11.9706 -3.67253 -4517 4 9.85969 19.2106 2.80597 1.71997 13.0916 -4.74013 -4518 6 23.4135 4.6314 15.2717 1.19087 -47.3757 24.1847 -4519 4 23.6596 4.57091 14.3636 3.27412 12.4021 -25.8415 -4520 4 23.0767 5.481 15.4712 -5.64379 31.4202 -0.243197 -4521 6 23.5143 41.6409 17.9193 15.1077 8.25095 -6.6202 -4522 4 23.8837 41.2632 18.7444 -17.9015 4.85421 -1.14363 -4523 4 22.6477 0.129763 18.1032 2.89941 -5.9973 3.37217 -4524 6 30.9257 4.8197 1.33225 52.4556 82.2644 21.8498 -4525 4 30.6067 4.04082 1.0087 -28.5575 -73.6424 -29.1188 -4526 4 31.8008 4.99709 0.898826 -20.2281 -12.9509 7.44496 -4527 6 29.2107 33.7595 18.6102 73.0072 -21.2941 -2.29721 -4528 4 30.2072 34.0216 18.5444 -47.9733 -6.17517 5.28057 -4529 4 28.7323 34.5281 18.37 -21.0864 31.3556 1.11974 -4530 6 23.1159 16.7161 3.6681 15.0693 -22.2232 4.2808 -4531 4 23.7494 16.3853 2.99745 -15.1451 3.0429 8.25243 -4532 4 23.0882 17.666 3.59926 -2.15966 11.8771 -4.335 -4533 6 34.9011 26.7664 31.7501 -1.76717 8.52767 -40.8429 -4534 4 35.037 27.6398 31.3273 1.29043 -2.59798 26.5044 -4535 4 34.999 26.223 30.9552 -0.698038 -3.54606 8.98008 -4536 6 7.10213 40.7731 20.9713 24.4432 1.2064 -5.23395 -4537 4 6.57619 40.3882 20.2802 -20.054 -4.79313 -9.64846 -4538 4 7.95521 40.8692 20.51 0.818491 4.17448 7.60026 -4539 6 52.4557 9.69054 11.9333 -13.8891 -19.4181 -13.3487 -4540 4 52.1298 8.88818 11.4535 9.48574 25.0976 13.8313 -4541 4 53.1611 10.0725 11.3936 -7.122 -1.8527 1.23238 -4542 6 12.0235 32.7598 27.7442 3.70099 -7.78602 -3.89203 -4543 4 11.3626 32.1501 27.3892 -5.86407 9.3821 3.02313 -4544 4 12.7405 32.6461 27.1218 9.18069 3.19616 2.31322 -4545 6 15.7918 18.546 0.850378 10.8461 -1.95532 -11.5883 -4546 4 16.438 18.9813 1.41668 1.29405 -2.87095 0.147979 -4547 4 14.9753 18.6242 1.3119 -21.1882 -0.0291689 9.92309 -4548 6 30.9967 13.9378 7.42939 11.475 1.61738 -44.5395 -4549 4 31.0432 13.5913 6.48715 -7.7997 1.97415 36.5778 -4550 4 31.6719 14.6391 7.43931 -7.46887 -7.66354 10.6483 -4551 6 23.9383 39.564 3.55488 34.3001 -22.0749 -10.0269 -4552 4 24.3437 38.8163 4.07249 -17.2972 16.8542 -11.2744 -4553 4 24.6493 39.7352 2.88999 -19.8697 7.819 10.5959 -4554 6 53.2452 13.9576 2.00229 -14.7116 -5.90049 -8.44118 -4555 4 54.0493 14.3984 2.24709 19.6807 0.169927 9.22775 -4556 4 52.9645 14.4205 1.20429 2.95034 -7.59818 -1.70329 -4557 6 29.4557 26.4275 7.80964 12.1022 6.02758 -9.79702 -4558 4 29.9353 26.7368 7.00545 -17.6775 -4.91001 19.2628 -4559 4 28.525 26.2807 7.58748 -5.08244 6.84096 -3.37299 -4560 6 24.6247 23.6022 31.0889 -22.8452 23.3962 -39.3716 -4561 4 23.7242 23.1866 30.9343 31.0198 16.8155 5.56769 -4562 4 24.7802 24.3072 30.3632 -7.32447 -41.3429 34.091 -4563 6 33.6649 19.3163 40.5091 -6.65541 -1.27585 7.81728 -4564 4 33.8354 18.657 41.2044 -1.67667 1.74775 -3.87809 -4565 4 34.3105 19.1562 39.8145 2.0445 4.20075 -4.1701 -4566 6 0.559384 35.9874 14.2134 5.8565 -19.6842 -1.82955 -4567 4 1.23941 35.9463 14.8996 -3.202 15.0395 2.84586 -4568 4 0.030681 36.7785 14.2979 -4.01885 14.7851 6.49139 -4569 6 7.05661 12.759 15.7779 -22.8667 -6.52104 17.6379 -4570 4 6.34583 12.5966 16.4564 20.9558 0.33122 -21.552 -4571 4 6.91757 12.0848 15.0954 -2.34629 3.44815 6.08752 -4572 6 7.88282 3.87818 22.4173 5.89555 -44.5054 15.1514 -4573 4 7.49019 4.56914 21.9267 -7.80716 26.896 -25.5563 -4574 4 7.61791 3.03791 21.9647 5.08594 18.6769 15.1101 -4575 6 50.7471 32.0888 16.2401 1.83727 42.1646 -7.06137 -4576 4 49.8752 31.8312 16.5285 -7.29916 -4.21179 -0.512004 -4577 4 50.6362 33.057 15.9791 5.96194 -37.4522 8.78354 -4578 6 15.303 18.2089 30.059 10.7923 -22.0796 25.2673 -4579 4 14.9011 18.5061 29.2675 -14.0638 14.0876 -27.3921 -4580 4 14.9173 17.3208 30.1974 9.34767 8.93092 3.04247 -4581 6 36.7231 25.4597 33.3812 -54.2725 16.2506 -34.9161 -4582 4 35.9173 25.838 32.8237 55.5216 -11.0114 39.6871 -4583 4 36.747 24.5432 33.1027 5.79642 -6.85026 5.14009 -4584 6 16.5358 21.8507 20.2615 -17.2006 3.10996 -10.5852 -4585 4 16.5318 20.9271 19.9881 4.62491 -6.39719 -1.16283 -4586 4 16.2171 22.3466 19.4835 8.40466 -0.269645 8.83911 -4587 6 44.2784 3.11614 30.075 -4.29151 -10.9085 31.9498 -4588 4 44.2908 2.23086 29.7056 -5.3385 -9.83615 -1.81045 -4589 4 44.5205 3.68982 29.3775 9.49019 22.102 -29.428 -4590 6 51.0822 14.1295 27.7742 -18.732 -33.3382 -1.30318 -4591 4 51.215 15.0658 27.7997 -1.99026 24.8352 -0.164216 -4592 4 50.1181 13.9695 27.6298 18.0185 9.91077 0.913588 -4593 6 54.1414 15.8836 27.1251 18.1892 -50.717 -21.9912 -4594 4 54.5758 14.9905 27.2793 -7.90108 34.3346 13.352 -4595 4 53.8259 15.7459 26.2068 -12.5208 17.6482 15.4671 -4596 6 26.7107 15.1629 34.529 26.3006 32.6175 -12.2305 -4597 4 26.7089 16.144 34.4655 -8.86078 -18.0829 7.52702 -4598 4 27.5163 14.9973 34.009 -10.4907 -11.0891 -0.654257 -4599 6 34.6699 2.22267 27.4725 27.1341 -12.2799 29.337 -4600 4 34.3153 1.93716 28.3227 7.08088 3.88889 7.09202 -4601 4 33.8991 2.25298 26.9555 -28.541 9.30381 -28.496 -4602 6 36.3083 17.6409 40.3953 7.68303 1.60807 9.57574 -4603 4 35.716 17.1791 39.8253 -12.5236 -4.37947 -14.4862 -4604 4 36.6569 16.9265 40.9504 1.18426 15.263 2.6664 -4605 6 26.2972 0.194896 33.0957 0.945324 -1.75644 -10.1569 -4606 4 26.0926 0.771392 33.8475 -8.68516 2.0119 1.91424 -4607 4 25.4691 41.6865 32.8295 -8.00507 -1.67316 12.192 -4608 6 5.19113 35.5773 31.6357 23.2413 -27.7984 27.0466 -4609 4 6.1476 35.7159 31.7435 -10.1506 4.22761 6.12862 -4610 4 4.96861 36.095 30.8978 -11.7512 22.2076 -38.0194 -4611 6 20.2191 22.0354 35.1304 9.30742 -6.19625 19.4235 -4612 4 19.9844 21.2003 34.7289 -5.16022 -6.81034 -3.33987 -4613 4 20.4782 21.7596 36.0473 -3.02096 9.85719 -25.9724 -4614 6 15.9251 36.5949 36.947 -9.13121 -30.7472 31.1466 -4615 4 16.4837 37.3712 37.0549 6.13876 -3.03661 -2.05614 -4616 4 16.031 36.0658 37.8159 -5.1453 16.1721 -39.9007 -4617 6 30.9484 22.4015 3.56131 11.993 -60.8988 -15.4947 -4618 4 31.1008 22.6958 4.44557 1.55935 5.74187 27.4751 -4619 4 31.2551 21.4217 3.58407 -13.4398 43.4536 -6.61432 -4620 6 47.0429 8.40936 14.2086 -4.42011 -15.6298 -34.0486 -4621 4 46.2603 8.29509 13.606 17.325 5.05196 18.7602 -4622 4 47.7698 7.89697 13.7682 -18.8904 11.0332 12.0247 -4623 6 34.1011 18.6159 3.148 0.361877 23.965 35.4915 -4624 4 34.6363 18.3397 3.89922 -0.845538 -0.743075 -4.07575 -4625 4 34.3812 18.1265 2.40098 2.04544 -17.9565 -29.3984 -4626 6 26.7996 25.3961 12.3408 -30.8906 -54.2954 26.5725 -4627 4 27.3117 26.1608 12.4557 20.536 44.4803 3.39785 -4628 4 26.6414 25.0259 13.2528 6.28377 9.49183 -30.6151 -4629 6 22.6108 25.7845 30.8845 17.3255 -0.303924 3.7754 -4630 4 23.4288 25.6954 31.4132 -11.344 -1.13015 -1.03332 -4631 4 22.2314 24.9052 30.7722 1.09512 -5.6623 7.4309 -4632 6 23.6311 9.76276 35.7585 -2.90797 -4.19552 -4.78319 -4633 4 22.8314 10.2832 35.6581 -5.74139 5.63622 4.02691 -4634 4 23.3139 8.86685 35.4998 11.2809 19.0625 6.63709 -4635 6 10.4076 36.7742 9.64242 -28.436 -9.9846 9.32351 -4636 4 9.50067 36.3875 9.59353 19.7531 11.7612 -0.53903 -4637 4 10.7226 36.8301 8.7426 3.69205 5.92187 -13.8772 -4638 6 4.00038 32.4265 25.8669 22.0714 10.4661 11.4497 -4639 4 4.38844 32.9375 25.1422 -1.34031 3.54398 1.69886 -4640 4 3.2706 31.9516 25.4996 -17.8371 -17.4963 -10.4987 -4641 6 29.085 26.0296 18.6527 19.273 -47.5776 11.2122 -4642 4 28.2115 26.0231 19.0264 -21.1607 3.13806 -0.423844 -4643 4 29.4632 25.1291 18.9323 -7.10954 42.4601 -14.5827 -4644 6 15.3089 1.3255 27.9792 -24.1234 20.5069 -17.5654 -4645 4 15.0496 0.974163 27.1169 2.04641 -4.01433 11.5068 -4646 4 14.7355 2.12388 28.0804 19.9995 -12.8223 4.08523 -4647 6 48.6106 2.88816 22.9655 -1.26722 3.55247 -0.201848 -4648 4 48.4165 2.02818 22.6182 -14.5439 -12.5884 3.03438 -4649 4 49.5001 2.98572 22.6432 10.4652 10.9023 -5.33271 -4650 6 53.0075 0.36099 19.7296 11.424 -8.43987 -8.95848 -4651 4 52.5965 41.9022 20.5162 -3.41206 4.78179 6.33318 -4652 4 52.3731 0.223553 19.0136 -6.83989 5.16364 0.289704 -4653 6 1.41074 17.5036 17.9462 -15.7932 -16.9445 -5.36496 -4654 4 1.29993 17.3585 17.0019 -2.92928 12.5396 -5.88676 -4655 4 1.38271 16.6004 18.2823 6.65411 -3.00458 14.0519 -4656 6 37.9084 19.0323 37.6056 -38.9323 8.68785 -13.5971 -4657 4 36.9858 18.7285 37.7384 11.3307 8.89304 -0.372118 -4658 4 38.4207 18.4342 38.1195 19.3518 -17.7067 16.118 -4659 6 26.9813 30.3571 38.0896 -0.527767 18.5171 -30.3811 -4660 4 26.1212 30.285 37.6565 1.23907 -9.17466 9.80696 -4661 4 27.2764 31.2069 37.701 2.1524 -13.2267 12.8694 -4662 6 20.0955 18.5722 3.03696 10.9017 21.9571 9.92937 -4663 4 20.0263 17.806 3.59422 -10.4522 -23.2015 2.62566 -4664 4 20.8322 19.0363 3.46766 -4.52129 0.073665 -16.3651 -4665 6 35.0841 6.94694 4.08385 8.40312 -14.6319 10.4582 -4666 4 35.6826 7.16069 3.3578 -1.64356 4.34706 -6.00978 -4667 4 34.2613 7.42764 3.99145 -7.61312 4.93718 -6.31016 -4668 6 22.2176 37.0878 31.2599 -35.8324 13.882 69.7054 -4669 4 22.1593 36.8558 30.3798 -4.04212 -13.8909 -61.3413 -4670 4 21.2552 37.1952 31.5589 44.4461 1.84169 -14.4682 -4671 6 12.3904 22.3711 41.8265 33.9103 21.3816 -17.5574 -4672 4 13.0623 23.0096 41.4404 -31.3175 -17.017 24.3472 -4673 4 11.7392 22.2302 41.1411 -5.71588 1.3909 -0.895108 -4674 6 43.2333 30.3145 23.1566 26.412 30.0652 1.94466 -4675 4 44.1443 29.9954 22.911 -23.9673 11.2944 4.28313 -4676 4 43.3588 31.2906 23.3811 -4.98348 -33.6726 -4.24118 -4677 6 16.5316 8.07904 16.6592 -13.1305 -2.58289 1.30551 -4678 4 16.426 8.46358 15.7881 -7.07274 -4.02537 -8.52635 -4679 4 17.4421 8.27811 16.8595 11.8389 2.77268 11.6749 -4680 6 10.0527 8.64979 31.7837 -8.97334 17.7557 -57.5223 -4681 4 10.1312 7.90747 32.3291 5.58005 -27.1767 37.8097 -4682 4 10.1183 9.47003 32.2578 1.92783 9.29621 23.4619 -4683 6 10.1389 6.52097 25.6279 25.2027 -9.57639 0.964906 -4684 4 9.42987 6.19895 26.1639 -19.2857 -8.54063 7.31181 -4685 4 9.7626 7.17299 25.0306 4.07146 -2.80849 4.96109 -4686 6 49.8614 7.23714 25.5252 -17.9172 7.62946 -5.56104 -4687 4 50.0467 6.31121 25.4422 2.69032 -18.6529 -6.42341 -4688 4 50.6907 7.63095 25.75 18.9978 12.6416 8.6826 -4689 6 18.4677 37.5766 33.9365 -27.5019 7.45217 1.11424 -4690 4 17.6855 38.1606 34.0956 24.1544 -3.52274 -4.16364 -4691 4 18.0518 36.7105 34.0373 4.53854 -5.63623 -1.47673 -4692 6 32.1991 34.7999 39.2511 37.7035 -28.7103 22.0041 -4693 4 32.3976 34.2973 40.087 0.14143 15.1618 -21.7552 -4694 4 31.3182 35.0784 39.3573 -42.2601 10.9481 4.26487 -4695 6 49.5371 23.9083 4.45427 26.1113 1.30104 -36.4507 -4696 4 49.7626 23.2251 5.06121 8.22711 -23.3511 16.8473 -4697 4 48.7895 24.3154 4.8182 -37.5883 23.1909 21.4935 -4698 6 6.05615 24.4755 33.9372 -3.62864 21.1406 1.2609 -4699 4 6.78781 23.8493 33.8811 -5.98028 -5.90455 -1.42734 -4700 4 5.44033 24.2071 34.6424 10.5748 -4.32926 -7.84557 -4701 6 1.71417 22.9797 24.1919 12.9465 25.751 -13.942 -4702 4 1.74027 23.9063 23.8744 -7.21984 -9.04225 7.93975 -4703 4 0.785802 22.7901 24.3299 -10.4675 -5.82386 8.34916 -4704 6 12.4544 16.5695 32.338 -33.1179 2.9171 31.5337 -4705 4 13.1434 15.995 32.5512 52.391 -27.2499 -12.3732 -4706 4 11.9701 16.4097 33.1768 -13.251 25.8897 -21.4653 -4707 6 21.3776 37.3784 27.9508 -6.73969 12.2577 23.3137 -4708 4 21.2203 37.3231 27.0262 1.16773 -1.52428 -34.5533 -4709 4 20.718 38.0458 28.2038 6.71566 -1.73666 8.03222 -4710 6 27.2299 40.8388 28.8031 2.48401 0.937021 1.60569 -4711 4 26.5367 41.5089 28.9565 6.65702 -12.2841 2.86921 -4712 4 27.4065 40.3185 29.6035 -12.9999 8.55112 -0.224288 -4713 6 0.993205 21.7261 13.5372 -53.3037 2.48171 -36.3839 -4714 4 1.86429 21.8093 13.8237 52.7771 -6.56786 29.3883 -4715 4 0.417346 21.4203 14.2472 8.63216 3.11646 10.526 -4716 6 22.3067 2.58146 8.73662 29.448 -13.2509 35.6107 -4717 4 22.9722 3.05705 8.24165 5.16658 9.50374 -8.2335 -4718 4 21.5154 2.5876 8.23764 -24.8297 4.23497 -21.3736 -4719 6 29.9953 17.8456 8.24313 -2.433 8.62767 -9.90081 -4720 4 29.054 17.6713 8.30654 -5.44558 -4.70631 2.21427 -4721 4 30.3746 17.4275 9.01982 5.69521 -3.15286 8.62416 -4722 6 3.62819 37.7118 25.7099 -17.1271 -24.8271 -10.3244 -4723 4 4.40422 37.1524 25.7956 9.9921 4.76654 4.66524 -4724 4 2.941 37.0477 25.4485 4.12723 25.8155 6.09629 -4725 6 26.809 27.648 36.3589 -37.7802 -17.2474 29.8166 -4726 4 26.8014 28.1831 35.5758 -1.13827 16.217 -13.4241 -4727 4 25.8725 27.5642 36.7259 28.3017 7.35189 -21.1707 -4728 6 13.3559 25.3099 38.116 1.93465 -14.8526 16.0582 -4729 4 13.2959 24.3789 38.4372 3.98877 20.6101 -4.99041 -4730 4 14.1146 25.694 38.605 -5.66874 -3.07699 -9.11419 -4731 6 49.7048 27.2599 6.72622 -1.43928 22.3256 -10.7839 -4732 4 49.6686 26.3369 6.45132 -5.99645 4.70457 -4.8273 -4733 4 49.2845 27.8697 6.04945 8.54794 -27.7312 19.0533 -4734 6 39.7449 11.5776 10.1987 6.84991 -8.95817 -1.04181 -4735 4 40.3059 10.8428 9.86803 -8.86198 19.4731 1.33094 -4736 4 39.0907 11.7833 9.50723 6.52335 -1.56097 1.75374 -4737 6 17.4857 24.9907 35.5559 -11.6728 -0.232318 -1.23817 -4738 4 17.2359 24.7743 34.6481 -9.71541 0.96097 3.2925 -4739 4 18.4326 24.9281 35.5495 18.729 -4.76527 0.24637 -4740 6 45.0886 34.9858 31.8393 -13.7853 -2.59791 -12.3576 -4741 4 44.2542 35.4282 32.0247 4.31579 11.0194 10.5125 -4742 4 44.8031 34.4855 31.0733 13.3341 -13.9746 -4.20839 -4743 6 30.2109 9.89077 31.3202 8.39813 20.0527 10.0978 -4744 4 30.4343 10.7522 30.9233 -1.69236 -11.2354 5.34707 -4745 4 30.0976 10.0887 32.2697 2.61193 -8.5831 -6.90929 -4746 6 32.3748 9.22464 6.61109 37.8815 -39.2378 -50.8405 -4747 4 32.2118 8.68084 5.76454 4.57858 20.451 35.1159 -4748 4 31.5433 9.4233 6.96427 -45.6188 15.529 19.6617 -4749 6 9.26845 24.9782 35.9229 1.19564 -9.02769 -15.4958 -4750 4 8.9564 25.4582 35.1216 5.49795 -4.99978 19.1154 -4751 4 9.87718 25.5584 36.4061 -8.42028 -2.10732 -11.5846 -4752 6 40.3335 1.48296 18.8902 20.9136 0.652934 -58.3414 -4753 4 39.6207 1.94237 19.2768 -32.228 11.5513 31.9135 -4754 4 40.836 0.952532 19.4949 5.43911 -12.9068 21.333 -4755 6 5.27733 10.6166 30.4293 -4.37857 29.6514 35.8012 -4756 4 5.00531 11.4476 30.0112 -0.880507 -1.63534 -8.13264 -4757 4 5.35863 10.9185 31.3957 -0.759826 -20.4729 -25.7258 -4758 6 25.6655 11.6994 25.6535 -15.8411 -39.3949 6.40341 -4759 4 25.8392 12.448 26.1908 9.94197 23.9877 11.5846 -4760 4 25.8146 10.9427 26.2759 4.01869 23.17 -23.7809 -4761 6 21.9208 20.0736 29.783 -0.661059 -23.1285 25.9828 -4762 4 22.5528 19.9674 30.5279 -9.0028 12.6586 -11.845 -4763 4 21.4796 19.2024 29.7633 3.30396 8.80601 -15.8778 -4764 6 10.0031 19.9894 34.5062 10.0701 -18.9504 -1.84201 -4765 4 9.43917 20.4787 35.093 -9.85162 7.82768 6.06887 -4766 4 9.97528 19.0642 34.823 3.96148 11.1077 -9.79004 -4767 6 24.6395 10.3611 12.2013 10.4056 19.7725 40.7349 -4768 4 24.7062 9.53294 12.699 -2.91134 1.50973 -12.3578 -4769 4 25.0089 11.0108 12.8733 -15.5791 -20.8054 -25.2752 -4770 6 50.4386 28.2959 11.551 52.3964 -11.4141 -41.8896 -4771 4 51.2944 28.7096 11.1811 -37.3824 -15.4271 20.8858 -4772 4 50.1484 28.8694 12.238 -9.02874 19.1251 18.783 -4773 6 13.9255 27.6321 25.0575 -30.7043 9.27758 -16.9407 -4774 4 13.4685 27.961 25.8505 6.53671 1.50814 -8.33226 -4775 4 13.405 28.0084 24.2853 19.6442 -13.6277 24.9436 -4776 6 46.1675 18.6723 40.4127 -24.7255 0.52235 -5.51451 -4777 4 45.2163 18.6287 40.1471 17.8616 -3.70574 0.193046 -4778 4 46.2526 19.5549 40.792 -2.63441 -2.56699 -8.45512 -4779 6 32.4875 14.1744 27.1342 -20.1773 -0.115465 -0.458595 -4780 4 31.894 13.6021 27.6676 10.0212 10.5514 -7.27374 -4781 4 32.1329 15.0809 27.2203 4.74838 -8.22403 2.71507 -4782 6 14.0641 36.351 13.3878 -9.69625 43.6715 -7.48797 -4783 4 14.0645 37.3444 13.3555 12.262 -25.9465 20.9036 -4784 4 13.2835 36.2347 12.8457 -5.28255 -22.0231 -7.64651 -4785 6 1.89477 36.5899 21.9857 -12.7075 -7.68583 0.53673 -4786 4 1.75133 36.5712 22.9388 2.01013 -3.06644 8.01032 -4787 4 2.81569 36.8315 21.8421 3.36212 -1.19737 0.805445 -4788 6 25.2943 31.8607 39.7417 -2.48011 0.614033 34.0265 -4789 4 24.999 32.7283 39.4716 -5.73903 6.77443 -6.35095 -4790 4 25.461 31.9431 40.7124 0.191009 -4.33082 -23.8473 -4791 6 6.4797 22.0186 1.29894 -12.0535 -14.7769 -6.17691 -4792 4 5.53353 21.8063 1.36197 11.0348 5.26157 5.70773 -4793 4 6.5732 22.8347 0.80957 1.58971 11.8894 0.78955 -4794 6 27.6266 25.0275 4.69979 7.76412 30.8855 29.066 -4795 4 28.5017 25.4862 4.66738 -16.9061 -15.4428 -5.02391 -4796 4 27.2115 25.3905 5.52919 8.95609 -10.8934 -21.2922 -4797 6 21.6474 30.9429 41.2213 -14.674 16.9935 -31.5335 -4798 4 21.3077 30.3434 41.8509 -10.7705 -24.5884 29.0962 -4799 4 20.9035 30.9616 40.5667 22.5963 5.39714 5.21952 -4800 6 32.3503 18.8691 12.7728 -7.52429 -0.383917 -18.241 -4801 4 31.3918 18.9773 12.8161 6.27066 1.36054 6.85895 -4802 4 32.4619 18.5656 11.8564 12.6246 0.663961 8.91714 -4803 6 35.6352 19.4593 21.1461 -10.1734 29.4522 17.7801 -4804 4 35.3511 18.62 21.5049 -2.07097 -11.6796 -4.30053 -4805 4 34.9906 20.1214 21.5255 16.9121 -20.2959 -15.2058 -4806 6 27.6974 17.9478 34.0105 3.72497 22.7808 11.4532 -4807 4 28.1244 18.3695 33.2449 -3.6365 -3.33971 3.70746 -4808 4 28.0134 18.5196 34.7467 -3.33496 -14.4526 -11.1074 -4809 6 34.1722 39.0415 14.8025 -0.588556 -5.09353 50.87 -4810 4 33.8492 38.3378 14.2426 -9.69809 -4.78927 -2.35124 -4811 4 33.6075 39.0103 15.6476 14.9636 10.6202 -38.8415 -4812 6 28.5063 3.47722 33.8826 -13.8698 -21.2799 4.06498 -4813 4 27.871 4.20321 33.9085 6.20243 8.28698 -1.91661 -4814 4 29.4175 3.76621 33.9059 10.9167 16.0273 -3.84391 -4815 6 34.9231 32.1486 6.55347 -48.5451 -22.9266 3.43697 -4816 4 33.9921 31.9748 6.9467 49.872 11.9331 -17.2337 -4817 4 35.5478 32.1135 7.28146 1.17984 3.66225 6.53991 -4818 6 31.8923 6.87344 23.517 2.73099 13.3553 4.48118 -4819 4 32.4005 6.72509 22.7097 -0.163961 -9.68163 3.8586 -4820 4 32.2042 7.75277 23.812 -2.19309 -5.80853 -1.60196 -4821 6 18.8495 1.74691 0.846251 -10.8424 6.73855 -33.2301 -4822 4 18.128 2.12906 0.287715 7.30697 -5.37966 19.0723 -4823 4 19.1812 2.42034 1.43504 -3.90896 9.02122 12.2654 -4824 6 27.0029 18.9235 11.8738 61.7268 20.0146 -35.0636 -4825 4 27.2277 19.7644 11.4142 7.64396 -16.2258 9.71345 -4826 4 26.1059 19.0334 11.9849 -72.3018 -1.47246 20.779 -4827 6 43.8315 11.1413 18.4425 12.0955 7.77381 31.2403 -4828 4 43.582 10.9955 17.5403 1.6883 -14.8273 -19.2234 -4829 4 44.4878 10.475 18.7348 -4.89818 7.49251 -15.5557 -4830 6 33.4942 40.5585 37.6724 7.87983 -3.11064 16.6213 -4831 4 33.9456 40.2455 38.4765 5.57637 6.44045 -9.71494 -4832 4 32.6057 40.2384 37.8499 -11.5443 1.61602 -9.31227 -4833 6 15.6218 26.7049 39.4143 -33.8245 -53.4627 11.7102 -4834 4 15.4245 26.9754 40.2985 -0.693124 5.44593 20.3253 -4835 4 16.1216 27.3809 39.0562 36.6223 43.7441 -31.7418 -4836 6 4.38199 13.876 40.8778 6.07973 -11.0772 -3.70535 -4837 4 5.33347 13.6897 41.0138 -14.6737 -0.272428 -1.39073 -4838 4 4.02273 13.2235 40.2449 7.64869 11.7946 8.98025 -4839 6 20.1779 10.396 38.2135 -21.4206 4.43784 1.78325 -4840 4 20.3564 10.9148 37.4134 10.9013 -11.3706 0.559506 -4841 4 20.991 10.2443 38.6984 6.99273 1.77474 -1.94206 -4842 6 15.1578 19.2491 23.8705 6.70925 0.197906 -4.49513 -4843 4 15.3523 20.1614 24.134 -1.79925 -4.44488 8.10361 -4844 4 15.0598 19.3463 22.9079 -1.20619 -5.61783 14.9214 -4845 6 47.881 28.6148 15.8048 16.8356 22.7469 11.8397 -4846 4 48.0602 27.74 15.4965 -2.52866 -23.0751 -5.40804 -4847 4 48.6281 28.8091 16.402 -10.5906 -5.01786 -6.93826 -4848 6 29.925 30.905 18.9707 11.7406 3.33263 -1.10353 -4849 4 29.0879 30.4807 18.764 -8.84985 -7.33813 -1.92291 -4850 4 29.807 31.8375 18.7873 -6.04184 4.11832 2.37084 -4851 6 11.9324 35.8064 28.512 -27.4265 24.0258 -21.7564 -4852 4 12.5706 36.1347 29.1334 15.2736 -4.81493 21.8335 -4853 4 12.2236 34.9831 28.145 8.79196 -20.6768 -0.490374 -4854 6 29.967 37.8624 25.4885 4.59009 -4.14727 -0.313094 -4855 4 30.2605 37.0012 25.8228 -4.78695 -0.224547 -14.1967 -4856 4 30.4431 38.4647 26.0537 0.190265 15.5785 7.27405 -4857 6 52.6385 28.1101 32.2696 27.4129 -14.0906 14.429 -4858 4 52.1837 28.8064 31.8018 1.35463 13.918 -3.63194 -4859 4 53.5572 28.4115 32.4361 -8.8806 -0.527566 -10.0859 -4860 6 37.0194 40.0856 11.9811 12.8522 -14.0915 -8.99985 -4861 4 36.2698 40.6335 12.1547 -20.3135 9.86443 5.11387 -4862 4 37.3206 39.8255 12.8594 7.06858 1.59634 4.17732 -4863 6 16.6823 16.7862 36.5016 -40.0159 24.4695 -22.7659 -4864 4 15.9639 17.4464 36.7433 30.1481 -22.6997 -3.51596 -4865 4 16.709 16.8774 35.5181 2.88256 -1.64708 20.873 -4866 6 28.0056 4.17661 38.8341 -15.1907 4.44859 15.1459 -4867 4 28.8664 4.34511 39.2253 10.7528 -1.70638 -4.98709 -4868 4 28.1362 3.72531 37.9969 -2.54795 -6.06729 -7.91519 -4869 6 28.9121 0.2613 17.7196 11.2429 43.6022 -6.13696 -4870 4 28.206 0.913023 17.5432 1.57334 -10.0134 0.986336 -4871 4 28.5175 41.3357 17.883 -22.7122 -29.353 3.51833 -4872 6 22.9275 20.1119 26.272 10.3141 -17.1908 1.54721 -4873 4 23.597 20.0083 26.9758 -6.33812 5.26805 -6.32666 -4874 4 22.343 20.8217 26.5441 4.5912 8.26641 6.04785 -4875 6 49.4104 29.8887 13.4211 -27.0365 40.5227 7.20695 -4876 4 49.0994 30.824 13.2506 14.963 -27.7355 -0.582388 -4877 4 48.6865 29.5209 13.9525 8.18699 -4.12202 2.86767 -4878 6 2.45827 24.8307 7.29137 -22.8365 1.45709 37.207 -4879 4 2.32025 24.5445 8.23446 11.0976 11.5137 -22.649 -4880 4 1.77037 25.516 7.1857 7.09177 -11.7652 -6.70138 -4881 6 30.3948 26.4611 14.3404 -21.8067 20.3233 2.80707 -4882 4 31.1122 26.3224 14.9982 -12.4575 10.0222 -1.69757 -4883 4 29.8137 27.2743 14.5309 34.7851 -33.9666 2.2264 -4884 6 27.0321 32.5068 3.14827 -14.3662 17.1598 1.60641 -4885 4 26.4039 33.1156 3.62616 22.1531 -16.0826 -13.2832 -4886 4 27.3831 31.9163 3.82559 -1.71579 -4.01879 3.19031 -4887 6 34.2634 14.7959 1.27313 2.99828 -7.05923 -10.0889 -4888 4 35.1835 14.4352 1.19997 -20.4533 4.23129 -4.55267 -4889 4 33.713 14.3258 0.588346 24.9828 8.52884 21.9593 -4890 6 30.022 8.54163 1.32868 -10.2939 -13.069 16.6852 -4891 4 30.0052 9.45247 1.0409 -5.08902 11.4157 2.73646 -4892 4 29.2496 8.43498 1.92915 15.9692 5.13326 -10.6744 -4893 6 42.5647 11.5185 27.7103 -4.68909 6.08661 -3.61857 -4894 4 42.216 12.3928 27.8946 9.09127 8.642 -2.18095 -4895 4 41.8714 10.9656 28.0604 -6.00702 -16.6262 4.78299 -4896 6 52.461 39.5492 17.8365 12.2605 -26.0754 -32.0817 -4897 4 51.7553 39.7908 18.3861 -39.7898 9.50592 28.6027 -4898 4 53.1226 40.1801 18.0155 30.5873 23.5517 5.0779 -4899 6 33.2136 4.91918 31.6183 -6.56942 36.6821 16.923 -4900 4 32.9061 5.86322 31.5606 3.78329 -26.1329 5.01225 -4901 4 32.8884 4.48208 30.835 -2.61462 -3.20134 -11.4125 -4902 6 6.2936 16 18.7476 -12.5252 7.31014 22.9936 -4903 4 5.79227 16.5246 19.4216 24.8679 -4.64947 -16.2991 -4904 4 5.64136 15.3462 18.514 -6.08951 -9.62478 -9.34051 -4905 6 8.52033 14.5365 24.6875 -9.84601 3.26611 -2.01077 -4906 4 9.36791 14.3624 25.0978 6.86066 0.30113 1.47813 -4907 4 8.18366 13.6846 24.3866 1.77672 -1.96336 3.84573 -4908 6 22.6911 10.1297 32.1351 -27.5214 -52.5729 10.3709 -4909 4 22.3884 10.9899 32.3649 2.47289 32.4289 -2.22619 -4910 4 23.5203 10.1223 31.6812 20.4751 21.0076 -14.9216 -4911 6 11.292 2.12704 14.679 -26.9964 -14.1635 0.457424 -4912 4 10.3004 2.01295 14.5746 25.662 7.6895 -7.09692 -4913 4 11.7079 2.38272 13.8392 -0.157448 -3.91762 -7.39795 -4914 6 44.9096 15.591 36.2717 33.6405 -1.91298 -30.8875 -4915 4 45.0764 15.4828 35.303 -3.33411 7.1012 27.4883 -4916 4 43.99 15.446 36.3379 -31.2371 -2.78707 10.2167 -4917 6 9.72465 19.0179 31.2227 19.6005 -24.8416 -16.8371 -4918 4 10.5897 19.4265 31.3159 1.30764 -1.40065 3.11778 -4919 4 9.11252 19.5759 31.653 -23.8989 17.913 16.8503 -4920 6 51.9714 7.58847 16.6881 21.0297 -20.8952 -55.8985 -4921 4 52.6598 6.90966 16.567 -10.1825 8.15334 22.1112 -4922 4 51.6538 7.5728 15.7392 -8.87714 21.5211 34.751 -4923 6 31.4317 34.7753 36.422 -0.942044 -9.40807 -31.2122 -4924 4 31.7249 34.7672 37.3268 6.30465 10.9632 14.3566 -4925 4 31.2441 35.6593 36.0754 6.17504 10.5044 11.3925 -4926 6 4.22663 15.0937 15.3657 -12.9272 -11.1361 22.285 -4927 4 4.10058 14.8824 16.3208 1.18356 5.05287 -17.269 -4928 4 5.17453 15.1773 15.2713 12.4851 5.61025 -4.39011 -4929 6 47.7531 20.6767 28.0224 11.2198 -3.02063 -12.9376 -4930 4 47.6925 19.771 27.6598 -2.10862 13.919 9.51432 -4931 4 48.3916 21.1163 27.4231 -12.1395 -0.81062 10.3277 -4932 6 15.815 1.15165 24.4078 -58.142 17.9603 -16.0616 -4933 4 15.2825 0.557615 24.9446 12.6892 -15.3828 1.22604 -4934 4 15.0545 1.63036 23.9524 41.7436 -8.72437 9.7488 -4935 6 34.5811 39.7067 40.0776 25.1973 35.6425 -42.1699 -4936 4 34.2041 40.3093 40.7031 -18.6223 -6.05265 24.4589 -4937 4 34.3171 38.8242 40.1905 -21.7766 -38.3424 16.3885 -4938 6 20.1959 32.1778 34.4064 -21.1308 28.8301 22.4919 -4939 4 19.7756 32.8897 35.0113 13.9702 -37.934 -23.8567 -4940 4 21.1121 32.1056 34.6926 -2.59197 2.17732 9.39736 -4941 6 19.2966 38.5284 11.8437 26.0429 16.0259 -0.414132 -4942 4 19.2747 37.5954 11.9891 -3.91225 -17.7096 3.53088 -4943 4 20.0654 38.8356 12.3915 -17.5462 -2.40166 -9.14392 -4944 6 6.53181 13.5016 26.8314 -26.032 48.4544 -13.2533 -4945 4 5.96734 14.0602 26.204 31.1233 -23.713 24.7575 -4946 4 6.50803 12.6321 26.4707 -0.853216 -24.803 -10.5103 -4947 6 23.5899 31.5666 33.3383 5.98922 -6.50638 -9.93577 -4948 4 23.0479 31.6137 34.1308 1.15429 -4.79335 1.92272 -4949 4 23.6428 30.629 33.0606 -7.31668 7.17491 0.194963 -4950 6 41.0566 31.9249 16.2102 56.5158 -30.8904 -22.4873 -4951 4 41.9283 32.0344 16.659 -25.525 5.07155 -0.752829 -4952 4 41.3339 31.2779 15.4895 -19.0587 21.5349 12.1439 -4953 6 31.7523 18.8667 19.3593 3.35741 25.414 0.712525 -4954 4 32.0759 19.7269 19.7383 -8.81617 -22.0304 -12.3923 -4955 4 31.2718 18.4298 20.0739 7.05067 -2.94537 3.38628 -4956 6 10.4941 4.11052 19.3414 6.42456 29.4713 -33.6332 -4957 4 9.72315 4.57262 18.9428 7.32966 -14.5804 7.11 -4958 4 11.2095 4.33965 18.6811 -15.5987 -11.1936 33.5314 -4959 6 1.36933 32.4682 19.2841 21.0988 -14.4161 24.2075 -4960 4 2.01529 31.7231 19.2122 -13.2253 9.85044 -10.2965 -4961 4 1.01532 32.721 18.4367 5.36339 -4.1954 -20.4987 -4962 6 42.8687 16.8583 24.9978 45.6636 -43.4462 -50.5941 -4963 4 42.5079 17.7172 24.9824 -17.3855 32.283 0.331695 -4964 4 43.4322 16.7911 24.1362 -30.0172 8.55702 44.8961 -4965 6 45.317 19.181 4.10785 3.8422 34.8536 -4.15721 -4966 4 46.019 19.8398 3.89275 -2.03222 -14.2005 10.5278 -4967 4 44.6424 19.7199 4.5744 3.59127 -10.0852 -3.22755 -4968 6 29.1417 19.8939 35.7514 6.11075 -32.58 -16.2332 -4969 4 28.6926 20.3067 36.4515 -23.9686 13.1333 31.3988 -4970 4 29.2427 20.5957 35.1143 7.28783 5.32225 -12.4577 -4971 6 31.9564 21.8498 19.6592 2.82401 14.2352 -0.350828 -4972 4 32.7548 21.9543 19.0677 -31.5105 -7.28354 24.2009 -4973 4 31.6217 22.7614 19.848 10.5207 -20.3739 -6.13763 -4974 6 39.1981 8.2717 18.8284 -32.9061 14.1933 0.428726 -4975 4 38.9624 7.35629 18.6463 1.07118 -6.83808 -1.96228 -4976 4 38.3348 8.76709 18.6863 31.0345 -14.9445 1.78619 -4977 6 33.2818 13.2775 41.2684 -13.2208 -33.3764 1.31987 -4978 4 32.393 13.5626 41.0006 -3.83673 2.91025 7.56978 -4979 4 33.1808 12.3338 41.5845 5.22215 22.8712 -2.04361 -4980 6 5.9413 29.5498 35.797 -32.456 -34.3071 -6.72563 -4981 4 6.35963 30.284 36.1739 22.861 33.0715 10.0739 -4982 4 6.49565 29.1835 35.1072 8.32337 2.91553 -5.44074 -4983 6 13.0321 34.2086 31.915 -24.835 -40.2345 36.8573 -4984 4 13.0272 33.4084 31.376 1.88868 -0.760633 -7.07942 -4985 4 12.5489 33.9041 32.737 18.271 18.5714 -18.1292 -4986 6 33.9591 21.7903 18.011 18.8454 -21.734 -8.71067 -4987 4 34.7458 21.1933 18.012 -16.5142 3.18134 2.17277 -4988 4 34.2934 22.6573 17.8484 16.983 20.6817 -10.003 -4989 6 35.9748 41.3385 18.1559 -11.3515 0.0380054 -35.3696 -4990 4 35.8093 41.5204 17.1769 9.12346 -12.4659 34.6458 -4991 4 36.6045 0.098617 18.3947 7.40652 10.177 5.52403 -4992 6 34.8515 37.6574 30.5934 11.7527 -35.7483 27.3047 -4993 4 35.1492 36.8608 30.1169 2.57906 15.2804 -10.7791 -4994 4 34.9371 37.33 31.5271 -8.43612 19.6249 -16.9201 -4995 6 26.002 34.4146 4.67279 -8.48904 3.78898 9.19231 -4996 4 25.4415 34.5852 5.42871 -16.9308 -4.98482 2.97274 -4997 4 26.7915 34.86 4.9592 18.7282 4.65341 -5.76761 -4998 6 19.0552 33.5605 1.32358 6.49267 31.5074 -37.6332 -4999 4 19.8139 33.1288 1.70335 8.38847 -12.1483 9.88993 -5000 4 19.4402 34.1326 0.589952 -11.7405 -21.1797 25.0755 -5001 6 25.2648 8.23393 8.59155 9.31521 -3.65292 19.8467 -5002 4 25.4875 8.13778 9.5404 -3.07709 1.08931 -10.3145 -5003 4 25.4314 9.16241 8.38927 -1.28134 -0.00667841 -6.07783 -5004 6 12.8479 19.6935 13.0483 24.3757 5.37981 -4.8091 -5005 4 11.9603 19.9957 12.9501 -28.6845 1.86907 1.18076 -5006 4 13.3523 20.516 12.8959 -4.89806 -16.374 -0.906345 -5007 6 53.3502 11.4299 5.80806 17.1624 -7.42289 17.7098 -5008 4 53.8461 12.0471 6.36061 9.49207 -4.93163 0.0376 -5009 4 52.6392 11.9481 5.49246 -25.6427 10.4986 -14.7278 -5010 6 9.84876 16.0411 31.2026 18.9205 20.8399 7.27663 -5011 4 9.06508 15.7062 30.7868 -18.8641 -2.54228 -13.3824 -5012 4 9.84527 17.0253 31.1624 -7.05614 -14.0763 0.861631 -5013 6 25.427 20.2931 3.30062 11.4464 23.222 26.9187 -5014 4 25.5454 20.7694 4.15249 -9.33169 -17.4988 -10.5652 -5015 4 25.6323 21.0333 2.7154 -3.32412 -15.1122 -12.6987 -5016 6 20.7611 8.20749 15.6389 12.285 -44.7943 -30.6071 -5017 4 20.4521 8.55687 16.4556 -20.4937 3.03897 24.5457 -5018 4 20.4185 7.27697 15.5079 3.31214 29.403 13.2982 -5019 6 37.6491 8.60321 9.97383 13.4411 2.14626 39.4708 -5020 4 37.9762 7.71523 10.2023 -7.3296 7.95364 -3.74733 -5021 4 37.281 8.55077 9.10696 -2.37522 -5.79058 -16.8845 -5022 6 50.6587 4.51935 24.2622 -13.5896 -19.0591 8.29097 -5023 4 49.9232 3.87067 24.2726 8.09814 12.5004 -4.89174 -5024 4 51.4381 3.99879 24.4754 4.23299 2.4676 7.18675 -5025 6 20.1738 24.8175 34.9087 -20.6162 39.8894 -22.5586 -5026 4 19.8889 25.4664 34.1955 11.6566 -19.5752 19.2833 -5027 4 20.4138 24.0094 34.4666 -0.241841 -16.354 -5.00311 -5028 6 30.5812 22.5243 11.2258 -36.8716 21.596 38.6978 -5029 4 31.1688 21.9929 10.7494 35.9784 -15.9007 -22.5785 -5030 4 31.0799 23.2498 11.6175 0.71333 3.79074 -7.65826 -5031 6 17.3246 40.781 8.03002 -31.7256 21.6985 11.3561 -5032 4 17.3609 40.073 8.69249 8.70624 -3.14378 -12.3263 -5033 4 18.1517 40.9293 7.58873 21.0517 -16.9909 -7.06703 -5034 6 23.9551 41.0422 26.0635 49.9815 4.82526 35.6353 -5035 4 24.3667 40.5978 25.3173 -4.54613 -3.84774 -13.2149 -5036 4 23.0402 41.1884 25.9461 -38.539 -4.36769 -14.447 -5037 6 9.79432 25.5848 27.2203 6.65484 -20.1236 -27.319 -5038 4 10.0774 24.9678 26.4912 -4.54744 21.2611 22.5851 -5039 4 10.2742 25.3181 28.0139 -2.97183 -5.43805 2.20583 -5040 6 35.2559 29.8148 24.7567 4.66903 26.9266 -5.93859 -5041 4 34.3843 29.755 24.359 -8.51564 -12.4096 -2.57191 -5042 4 35.4992 30.7322 24.5163 3.09853 -9.53322 8.65044 -5043 6 2.14554 4.24448 10.5593 -22.2482 14.7122 10.1934 -5044 4 1.71214 4.34677 11.4486 21.0071 -10.277 -13.7719 -5045 4 1.55235 4.73342 9.96914 3.10164 -3.012 2.95666 -5046 6 43.1737 3.93442 23.504 -19.8173 -22.9925 0.828755 -5047 4 43.8868 4.03822 22.8829 13.7397 8.75634 -8.56433 -5048 4 42.5624 3.30318 23.0634 7.12322 11.7882 3.68849 -5049 6 18.8936 22.6308 2.43475 37.4693 -11.6119 5.39147 -5050 4 19.8359 22.2985 2.41568 -31.8063 3.38645 -2.45846 -5051 4 18.7431 22.7947 3.37318 -4.67781 1.83629 -1.28906 -5052 6 20.5039 18.9394 41.5502 -45.0653 -1.00263 50.2155 -5053 4 20.0478 18.6838 0.506021 30.3651 -1.16827 -32.2456 -5054 4 19.9073 19.6506 41.2865 12.7012 -1.26976 -15.3796 -5055 6 26.407 7.54687 29.1121 1.4357 2.47637 1.41449 -5056 4 25.6724 7.10479 28.6297 19.9382 8.96422 9.98625 -5057 4 27.0918 7.77745 28.4582 -11.2115 -7.41118 6.83701 -5058 6 25.6474 35.5684 33.7551 28.3954 -27.4775 -24.9773 -5059 4 26.3573 36.1942 33.5448 -9.56627 7.56335 10.8035 -5060 4 25.9974 34.7724 33.2466 -29.6941 19.0168 23.1671 -5061 6 24.829 0.49304 8.41898 49.9168 25.8876 59 -5062 4 25.5758 0.370102 9.1289 -47.1903 5.46774 -40.7742 -5063 4 24.7798 41.5674 8.0141 -4.73142 -31.3088 -22.2887 -5064 6 17.0191 17.3177 3.44507 -46.3903 19.7373 51.2207 -5065 4 16.2469 17.9517 3.64762 33.8447 -23.651 -21.8207 -5066 4 17.1185 16.9245 4.35427 5.98982 5.76213 -27.3591 -5067 6 40.1787 32.0965 19.3495 -2.04197 44.459 1.39821 -5068 4 39.7315 31.3261 19.6693 2.08081 -28.8107 0.337304 -5069 4 40.9568 31.869 18.8472 6.84111 -19.9226 -1.15348 -5070 6 23.382 26.6945 6.30636 26.5913 52.1271 15.5788 -5071 4 24.0556 27.4456 6.44648 -17.1373 -33.2326 -1.34025 -5072 4 22.7142 27.1153 5.75328 -6.08389 -4.52619 -7.61988 -5073 6 28.6524 28.5085 1.41248 40.8971 -13.4399 -11.1281 -5074 4 28.8916 29.4207 1.30452 -22.1266 20.7664 -4.28256 -5075 4 29.5558 28.1704 1.18501 -32.1523 -8.03877 13.3744 -5076 6 12.0456 6.33448 14.0345 -15.8903 -34.4 -29.7535 -5077 4 11.2902 6.05291 13.4483 16.0844 18.9407 21.6686 -5078 4 12.7823 5.99392 13.4906 5.33453 16.7776 14.1371 -5079 6 20.1258 33.7078 32.0959 -18.1893 1.56867 -4.93457 -5080 4 20.1945 33.0222 32.7471 -6.29187 -8.74149 18.477 -5081 4 21.0272 33.8529 31.8657 20.6776 7.89431 -10.0095 -5082 6 12.0665 33.3691 34.5458 -17.2285 -56.0193 -22.1145 -5083 4 11.5086 33.8793 35.1106 -7.76206 16.4549 16.9315 -5084 4 11.5605 32.4987 34.4127 27.4292 33.0374 0.608769 -5085 6 6.00658 22.2666 25.0532 -19.3255 -5.39958 94.237 -5086 4 5.834 22.4197 24.1868 -9.01045 11.6196 -89.8037 -5087 4 5.17345 22.6031 25.4913 31.6285 -9.76338 -3.83253 -5088 6 28.8848 9.49767 11.035 16.7623 9.63116 22.4077 -5089 4 29.0495 10.2086 11.6768 10.1151 -22.3542 -11.392 -5090 4 28.083 9.83925 10.6889 -25.6685 -5.48517 -25.0151 -5091 6 25.9808 31.1499 24.8669 6.22835 -24.9986 7.12483 -5092 4 26.2942 31.9621 24.5011 4.31737 18.7644 -10.9339 -5093 4 26.6597 30.4768 24.6157 -18.0541 8.02771 8.13926 -5094 6 17.4051 22.6403 26.9653 -7.75883 36.9734 2.0054 -5095 4 17.2144 23.5004 27.4753 3.96627 -41.4428 -18.3441 -5096 4 17.5261 21.9375 27.6083 1.93016 -8.19761 6.25563 -5097 6 30.9714 17.6252 1.64088 21.0154 14.9482 37.3685 -5098 4 30.2059 17.6112 1.0839 -20.4324 5.80492 -14.3468 -5099 4 30.9516 18.4373 2.23396 3.22156 -25.7853 -22.8165 -5100 6 35.2764 9.72503 11.2414 -18.3895 -2.76749 -51.624 -5101 4 34.6551 9.56245 10.4589 20.7383 2.80865 37.1903 -5102 4 36.1302 9.43155 10.8742 2.68762 -2.05229 10.7544 -5103 6 12.0172 10.802 4.27563 -38.9121 -6.07101 -4.90761 -5104 4 11.4313 10.6374 5.04504 13.8247 1.49432 -7.40831 -5105 4 11.4074 10.5604 3.53263 22.811 5.33779 9.30002 -5106 6 52.9577 23.1313 7.67787 -9.3269 3.09364 -7.79077 -5107 4 53.8153 23.0871 7.22609 1.51949 2.98805 -1.25247 -5108 4 52.6879 24.0607 7.78743 10.5919 -6.87524 0.0783357 -5109 6 27.3762 5.80009 23.1013 37.771 37.8703 25.2466 -5110 4 28.2178 5.56094 23.5856 -32.2451 -1.57897 -13.9899 -5111 4 27.4704 6.79781 23.0764 -15.1432 -38.3322 -6.34326 -5112 6 22.7771 37.7063 15.5287 -6.89324 -10.2053 44.7861 -5113 4 22.8198 37.7465 14.5962 3.81902 5.91484 -35.4551 -5114 4 23.2903 36.9427 15.8415 -1.83068 2.7653 -4.67104 -5115 6 30.583 30.1381 39.7472 11.9278 5.78959 4.89923 -5116 4 30.1399 29.6129 39.0656 -4.27402 4.25284 -2.63349 -5117 4 30.6547 31.067 39.4612 -8.3831 -13.7724 -7.9353 -5118 6 26.5154 14.8633 29.9609 11.0831 -12.5589 -33.9006 -5119 4 25.6935 15.2477 30.2118 -18.1143 15.4408 19.147 -5120 4 27.1376 14.9035 30.6723 6.99544 5.71887 23.1856 -5121 6 9.52617 19.5446 37.4141 -27.8096 33.0225 -3.94279 -5122 4 8.56344 19.6819 37.5998 22.5694 -19.9005 4.13551 -5123 4 9.71087 20.3892 36.9619 8.68778 -16.8671 10.038 -5124 6 0.93064 14.8656 2.69338 -45.7679 -11.5139 71.6593 -5125 4 1.44105 15.217 2.01526 37.3122 25.2366 -40.5783 -5126 4 0.982855 15.4275 3.5214 11.2099 -15.0526 -29.9277 -5127 6 46.4291 27.1302 41.5927 44.8021 -5.11347 -18.4756 -5128 4 47.4269 27.1857 41.3316 -52.8753 -1.56841 10.8767 -5129 4 46.0453 26.5632 40.9031 3.09365 7.20255 7.14326 -5130 6 47.6703 23.0461 21.3817 14.1329 62.5249 18.4178 -5131 4 46.9615 23.2467 20.7836 -14.1781 -2.67912 -10.5965 -5132 4 47.8255 22.1376 21.4096 0.736735 -54.6337 -3.62162 -5133 6 39.861 22.2186 3.09273 14.3751 -13.6386 -17.8056 -5134 4 38.9812 22.2192 3.47284 -7.54245 -0.786418 6.90323 -5135 4 40.0217 21.2868 2.78929 -10.5756 29.8648 14.1337 -5136 6 14.9857 14.9315 33.4628 8.45923 30.4043 17.83 -5137 4 15.3946 15.8263 33.6275 -11.7248 -28.7506 -9.93609 -5138 4 14.5839 14.7058 34.318 1.67348 -1.86342 -8.89677 -5139 6 27.3225 11.4951 31.9326 -53.5602 -46.3542 13.457 -5140 4 26.8632 12.0627 32.5566 10.8872 8.4751 3.08438 -5141 4 28.1269 11.8297 31.6518 53.6341 36.944 -15.9306 -5142 6 36.7606 7.97817 7.63938 -5.6216 -14.483 -15.6739 -5143 4 35.961 7.43887 7.80711 8.78578 3.79539 -7.6162 -5144 4 37.414 7.37034 7.2323 -6.45073 3.96969 3.37374 -5145 6 49.4351 9.64395 18.2091 29.626 55.2849 10.866 -5146 4 50.1121 10.1978 17.7651 -9.80365 -29.4086 -13.348 -5147 4 49.2806 10.2909 18.9191 -22.4891 -21.6225 2.73598 -5148 6 27.0558 33.8708 10.7695 -35.2964 21.4972 9.63291 -5149 4 27.0077 33.3399 10.0051 13.5655 -23.8621 -34.587 -5150 4 26.1863 34.3133 10.6733 10.9844 1.63438 18.9088 -5151 6 11.1931 37.467 6.82672 4.88099 -16.6436 19.1561 -5152 4 10.8369 38.341 6.72067 -6.30082 13.8936 -5.38019 -5153 4 12.1372 37.6177 6.93955 5.33816 -5.06614 -4.03667 -5154 6 19.2682 19.4041 21.904 -23.2853 8.1035 46.9014 -5155 4 18.5523 19.4276 21.2977 -21.2798 -5.04156 -20.5384 -5156 4 20.0545 19.4439 21.4012 35.6905 -5.22778 -21.4405 -5157 6 54.5004 2.91828 22.5705 32.5661 -1.01917 48.733 -5158 4 54.2618 3.02388 21.6728 -2.16971 10.501 -40.9175 -5159 4 0.435524 3.25313 22.7695 -30.9494 -6.38648 -13.13 -5160 6 45.0599 10.868 24.2364 14.5135 -18.2796 4.13426 -5161 4 44.3635 11.4663 23.9664 0.226806 13.7258 12.1538 -5162 4 45.5813 11.1999 25.0017 -10.9868 0.331296 -15.4884 -5163 6 14.3917 34.4176 24.7766 -9.76404 -18.453 -6.38428 -5164 4 14.7761 35.2693 24.9957 4.99605 2.44674 1.2141 -5165 4 14.8449 34.0832 23.9904 0.575187 7.45256 -7.27956 -5166 6 50.5869 17.5623 4.30497 19.1488 -58.6727 24.3661 -5167 4 51.3501 17.8958 4.78847 0.670503 12.5806 -1.04554 -5168 4 50.1422 18.2474 3.88142 -19.7161 48.0777 -23.3625 -5169 6 14.9242 33.337 34.1076 -18.6172 33.5363 80.554 -5170 4 15.0808 32.9083 33.3321 11.226 -38.5345 -73.3592 -5171 4 14.0723 33.0217 34.4665 7.96171 10.4343 -9.42002 -5172 6 20.8631 33.5747 38.9135 21.2953 11.2024 -25.7312 -5173 4 20.865 34.0752 39.7143 -3.94121 7.45437 24.6588 -5174 4 20.36 32.7884 39.0656 -12.436 -21.6406 1.81461 -5175 6 7.7707 4.74963 26.7362 26.5342 -10.6541 19.1955 -5176 4 7.23261 4.91898 27.5026 -6.83786 10.9421 8.37469 -5177 4 7.15089 4.73593 26.0203 -3.95236 1.60233 -15.9617 -5178 6 9.2875 21.4887 22.2941 45.0197 -19.5209 20.7118 -5179 4 8.6739 21.9912 21.7696 -4.21454 15.1903 -23.2464 -5180 4 10.2572 21.6206 22.0058 -46.5259 5.6334 -2.177 -5181 6 20.5439 38.2154 8.85856 -11.8412 3.64647 49.7312 -5182 4 20.3505 38.5634 9.79035 9.75602 -4.66312 -40.2998 -5183 4 20.2844 37.2891 8.95048 10.2824 2.6457 -7.05014 -5184 6 30.1005 39.0839 30.7484 -12.1958 38.1552 23.9792 -5185 4 30.3724 39.9578 31.2326 -12.541 -45.9124 -25.2432 -5186 4 29.1103 39.003 30.8437 30.6219 6.07536 -1.13857 -5187 6 16.0462 22.036 24.5064 2.37861 -9.55962 -5.99251 -5188 4 16.6334 21.9741 23.7207 6.17482 7.89117 19.2285 -5189 4 16.5569 22.3155 25.2979 1.4399 -2.17025 -8.02685 -5190 6 5.74172 29.2061 14.4603 -14.7312 11.1013 -1.58992 -5191 4 6.41865 28.6839 14.8489 24.8954 -16.4528 0.429681 -5192 4 5.37542 29.618 15.2515 -13.4536 5.99623 -6.25212 -5193 6 28.0689 3.08071 25.2267 -3.20814 35.3244 14.901 -5194 4 28.6407 3.76435 24.8336 -2.36389 -14.401 -4.10269 -5195 4 27.6795 3.6106 25.9691 7.41152 -23.0621 -10.2478 -5196 6 45.9381 29.3111 31.4283 -35.5447 25.9568 9.82539 -5197 4 45.677 28.707 30.7493 2.31008 -18.1922 -21.3643 -5198 4 45.1265 29.9079 31.4744 34.4717 -15.8255 11.1052 -5199 6 11.2229 22.8376 36.7897 -1.27591 2.9175 -5.69903 -5200 4 10.6623 23.4314 36.25 10.4728 -5.78036 -0.0474996 -5201 4 12.0147 22.5841 36.2713 -9.37786 4.28983 5.66853 -5202 6 18.9444 40.1485 39.92 -15.471 -8.01044 2.33142 -5203 4 19.1439 39.1941 39.9507 -1.34087 5.25319 4.4419 -5204 4 18.8847 40.4877 40.8271 3.43659 -8.21326 1.76593 -5205 6 23.5503 26.0803 21.2869 1.98517 -8.46863 16.2364 -5206 4 22.847 26.649 20.9475 -0.393515 -5.32061 4.06564 -5207 4 23.2913 25.6403 22.1336 -2.29953 13.2014 -21.5927 -5208 6 16.8518 5.38834 15.8565 -25.8193 5.07215 -6.0744 -5209 4 16.3979 5.3834 15.0179 8.08064 -16.6857 -11.3384 -5210 4 16.3642 6.13153 16.2159 17.5374 8.90145 23.838 -5211 6 12.0293 26.6115 15.0052 48.8575 28.3431 -20.5386 -5212 4 11.753 25.9113 15.557 -22.1508 -25.2102 16.954 -5213 4 11.3677 26.9943 14.4309 -20.7091 -9.23994 -0.184726 -5214 6 14.3404 41.4231 2.37222 21.8802 31.2536 -15.2067 -5215 4 13.6639 41.0433 2.88545 -29.1815 -25.4177 23.2655 -5216 4 14.3137 0.446574 2.65591 6.04323 -12.5169 -2.89291 -5217 6 50.3994 35.8721 9.32148 7.74023 -5.00078 -0.0244409 -5218 4 50.7985 35.7097 8.44539 1.7624 12.9821 5.72804 -5219 4 50.9327 36.5364 9.8137 -9.76519 -8.88391 -14.7497 -5220 6 11.3732 22.6657 26.8674 13.5542 4.36995 9.37334 -5221 4 12.2226 22.4007 26.49 -3.86507 -2.48494 3.34128 -5222 4 10.7274 22.4174 26.2153 -14.8849 -5.84603 -9.40936 -5223 6 8.44501 34.5567 21.2657 -4.1178 -59.9386 7.63204 -5224 4 8.06567 35.1301 21.9247 -8.42944 2.78434 16.8569 -5225 4 8.10966 33.58 21.4462 13.1168 58.8803 -11.2866 -5226 6 9.4289 8.66253 24.4817 -31.3326 14.2813 -20.5935 -5227 4 8.45611 8.64572 24.2655 24.8039 10.7682 6.42659 -5228 4 9.52915 9.21836 25.2644 -0.461641 7.68001 5.20174 -5229 6 32.603 22.3274 34.5057 1.1064 -2.38466 -37.2003 -5230 4 32.4525 23.1707 34.0368 4.85154 -2.46017 7.68642 -5231 4 32.8396 22.5701 35.3818 7.58742 14.9461 32.9529 -5232 6 26.736 26.1837 7.12165 10.4716 16.8024 -17.1295 -5233 4 25.9537 25.8031 7.51207 -7.84415 -15.2109 12.7352 -5234 4 26.4604 27.1054 6.93432 8.77765 -19.2484 4.4957 -5235 6 34.0014 11.9295 3.96807 -3.56186 4.82634 5.33773 -5236 4 33.6494 11.5631 4.78494 7.3544 2.33703 4.85457 -5237 4 33.8594 12.8842 4.06904 0.478869 -2.08104 -5.13073 -5238 6 21.473 20.924 37.1992 5.8677 19.4674 12.3893 -5239 4 22.3242 21.3752 37.157 2.6693 1.87465 3.04951 -5240 4 21.708 20.0203 37.0255 -6.20277 -25.1527 -1.47337 -5241 6 18.4792 41.0219 0.672743 -35.2491 -25.3697 -26.4792 -5242 4 17.5363 41.1592 0.451811 6.2729 -6.09178 6.10687 -5243 4 18.7532 41.8934 0.847545 18.5165 37.9853 8.81983 -5244 6 41.3458 41.7141 25.1818 17.8335 14.8146 -1.57438 -5245 4 40.8444 40.9381 25.3951 -6.7286 -20.9895 5.67055 -5246 4 41.5773 41.6158 24.2546 -2.61686 2.51709 -2.2804 -5247 6 27.6337 28.128 3.93443 68.2433 49.922 -72.4808 -5248 4 27.747 28.0641 2.90056 -5.60951 6.59214 55.905 -5249 4 26.974 27.5707 4.19301 -60.7891 -51.6503 16.466 -5250 6 18.2766 10.5218 31.4985 31.6557 -13.945 -4.11948 -5251 4 17.4661 10.038 31.5755 -21.8827 2.32902 1.26527 -5252 4 18.1351 11.463 31.4681 -8.30794 8.79106 3.21692 -5253 6 11.3047 37.9513 14.7719 14.2766 22.5792 8.51892 -5254 4 10.8196 37.2524 14.3384 -3.55752 -10.2024 4.33151 -5255 4 11.8722 37.607 15.4977 -19.1201 -2.12261 -16.4117 -5256 6 0.810718 18.1323 27.5767 30.9572 19.3393 -0.702274 -5257 4 0.190255 17.4711 27.3024 -13.6082 -17.9307 4.12615 -5258 4 1.6652 17.6816 27.7433 -15.3641 2.36995 -0.952151 -5259 6 36.7957 10.7342 20.2882 16.9593 17.0847 7.18326 -5260 4 36.2525 10.0089 20.0111 -13.8544 -11.0907 -5.31633 -5261 4 36.5766 10.8708 21.2175 -0.466777 -2.92115 4.06643 -5262 6 47.4269 25.5204 8.035 -8.77625 7.04012 -26.0141 -5263 4 47.2351 25.672 7.07342 16.0738 -5.10236 26.6147 -5264 4 46.6031 25.1946 8.38488 -7.38433 -0.0309169 8.21918 -5265 6 13.9121 35.1279 15.9963 57.6206 21.904 15.8158 -5266 4 13.18 34.6338 16.2776 -41.6081 -30.4219 4.97616 -5267 4 13.8612 35.4714 15.1124 -11.7278 3.29634 -19.5683 -5268 6 29.56 35.3617 16.1847 -46.2751 8.28104 -14.7299 -5269 4 30.2098 34.9035 16.6971 16.3841 -9.08849 15.1595 -5270 4 28.6495 34.9755 16.3324 34.0842 8.73794 -6.93478 -5271 6 29.4892 25.8842 32.4194 -24.256 -10.4352 -29.1805 -5272 4 28.8256 25.7516 33.0892 -1.91161 2.59937 23.0953 -5273 4 29.0388 25.4531 31.6468 24.6149 5.96309 7.68736 -5274 6 24.1242 2.12171 25.4449 33.2745 25.8541 -21.7468 -5275 4 24.4973 2.84525 24.8288 -6.14236 -31.0627 26.9036 -5276 4 24.7925 1.39916 25.5361 -16.9688 12.032 -10.1501 -5277 6 4.54733 34.4389 19.1463 -35.302 -7.10976 -3.39284 -5278 4 4.35486 34.5879 18.2161 16.9971 0.874352 -7.12679 -5279 4 3.63202 34.4395 19.5005 25.743 -3.14875 11.9651 -5280 6 10.1206 17.2361 14.3164 8.36708 -29.6599 -28.3251 -5281 4 10.306 17.5039 15.1955 -0.106022 16.7729 24.4966 -5282 4 9.5035 17.8022 13.8616 -7.59249 10.3925 2.01091 -5283 6 21.4437 41.7724 34.6698 -12.6382 -8.67476 11.1219 -5284 4 21.3209 41.1297 35.367 19.1323 -10.7035 11.8578 -5285 4 20.52 0.052046 34.4982 -0.738196 4.11389 -17.598 -5286 6 36.1618 24.1149 12.6039 -38.5184 -29.276 -18.6614 -5287 4 35.5274 23.7914 13.2897 25.4622 4.78071 -2.2183 -5288 4 35.751 23.7447 11.7708 17.6549 15.9976 15.8112 -5289 6 49.5813 18.6026 19.9424 19.3655 4.31785 -3.79274 -5290 4 50.05 19.3681 19.5461 -11.4841 -9.87428 2.01803 -5291 4 50.2881 17.9408 20.0283 -8.44417 3.53865 1.64593 -5292 6 1.24663 7.05846 14.4912 39.2605 -25.8072 -27.0237 -5293 4 1.83321 6.85564 13.6734 -27.5618 7.792 37.3713 -5294 4 1.40902 6.33035 15.1313 0.69425 14.6008 -10.3474 -5295 6 12.7431 22.7725 31.2519 -28.0711 -22.2846 -24.537 -5296 4 12.731 22.0484 30.5842 -1.03989 14.4355 17.1556 -5297 4 13.6361 23.0601 31.2889 29.0982 7.61123 0.941905 -5298 6 8.17623 18.6217 27.8167 28.4831 -7.95646 -20.137 -5299 4 8.40342 17.6669 27.8028 -7.19499 14.8132 8.92302 -5300 4 8.90402 18.9943 27.2753 -13.5351 -1.9306 8.34595 -5301 6 52.1398 28.0368 15.3061 -5.99984 -2.63203 -6.56281 -5302 4 52.212 27.4921 14.5152 3.50742 -7.1981 5.43712 -5303 4 52.1344 28.9249 14.9274 -1.52971 -5.17654 6.68842 -5304 6 52.6974 21.8977 10.081 -19.9085 6.90605 5.3514 -5305 4 53.3388 22.3376 10.626 19.2735 6.64212 5.60719 -5306 4 52.8023 22.3165 9.21858 0.448532 -1.39229 -3.54893 -5307 6 22.3312 5.79987 2.67028 14.2956 -6.96789 22.7666 -5308 4 22.4342 5.66665 3.62826 -7.95027 2.50856 -4.24886 -5309 4 22.7763 5.02131 2.34757 -2.68692 -18.1597 -17.0707 -5310 6 15.4178 16.2178 21.8878 29.1139 16.3559 -34.9346 -5311 4 14.4763 16.1482 22.0206 -17.0561 3.51129 1.66656 -5312 4 15.5967 16.6295 20.979 -16.1676 -12.6325 35.129 -5313 6 28.6996 41.2944 33.8986 -0.299799 0.972013 4.01662 -5314 4 28.6528 40.5712 34.5346 5.69191 -6.81028 -1.89437 -5315 4 27.7925 41.4039 33.5788 7.00998 2.71453 4.16387 -5316 6 9.0271 31.2603 18.2166 -24.0632 3.5617 9.69965 -5317 4 9.00312 32.2249 18.3215 -0.833429 -0.795431 1.49639 -5318 4 8.39564 30.8695 18.8792 23.5138 4.17381 -14.686 -5319 6 20.5401 20.4009 18.1765 -9.82111 13.5354 -7.0052 -5320 4 21.0961 20.6619 18.9088 6.00228 -1.57494 14.3732 -5321 4 19.8969 21.1451 18.1138 9.42471 -20.4088 -2.28899 -5322 6 53.9632 14.7108 37.8185 38.9936 -13.777 37.4998 -5323 4 53.5065 15.4999 38.0588 -19.2143 21.2037 -5.62994 -5324 4 53.6553 14.2856 37.0504 -18.643 -5.89619 -29.3657 -5325 6 28.9005 15.3805 18.8553 43.4355 2.75939 -10.7082 -5326 4 29.8744 15.2601 18.5577 -43.1698 -4.30042 15.6378 -5327 4 28.8821 15.3937 19.8257 1.95554 -2.72042 -0.550014 -5328 6 2.00757 25.8231 18.9102 1.56834 13.1457 16.4238 -5329 4 2.16994 26.6099 18.3718 5.10623 3.14141 1.15535 -5330 4 1.76535 25.1325 18.3092 -5.75322 -15.1157 -18.9078 -5331 6 53.2586 40.7003 24.294 -3.95682 23.2035 5.10337 -5332 4 53.3627 39.7881 24.0333 10.577 -13.1769 -1.30533 -5333 4 54.0929 41.151 24.0537 -8.8009 -7.19084 1.91562 -5334 6 47.531 32.0044 22.8424 -9.22212 4.73076 14.8806 -5335 4 47.3777 32.6735 23.5302 -5.63931 6.65432 -9.88941 -5336 4 48.2144 31.4763 23.2497 9.41484 -5.26157 -3.09765 -5337 6 24.6289 26.1478 33.0175 -22.0968 -9.02062 -12.6011 -5338 4 24.4656 25.5474 33.7557 -1.10221 8.12594 5.97613 -5339 4 25.4283 26.6445 33.1202 14.9272 4.196 4.65224 -5340 6 21.3417 17.0876 39.4763 -6.70912 6.89414 0.748051 -5341 4 22.0272 16.5901 39.8927 14.9242 -9.38388 2.18929 -5342 4 20.9728 17.5957 40.2063 -4.43123 6.71259 -1.60026 -5343 6 11.0417 40.4515 17.0271 -4.84825 -47.9733 -31.3307 -5344 4 11.617 41.1325 17.3235 21.4854 16.9952 0.793724 -5345 4 11.529 39.8797 16.3454 -22.439 27.66 32.3414 -5346 6 20.3522 21.2696 39.8718 -25.2322 13.8952 23.2629 -5347 4 20.7065 20.9823 39.0558 13.3567 -12.8249 -34.1322 -5348 4 21.0787 21.2544 40.4999 1.2931 1.07094 1.93889 -5349 6 2.11891 29.6947 22.5962 -10.9271 -4.15175 -1.48688 -5350 4 1.41229 29.0196 22.6861 11.0269 1.69063 -12.8134 -5351 4 2.97173 29.2673 22.4434 -6.16143 -1.40449 -3.11444 -5352 6 36.756 30.301 35.4561 22.3149 -30.6991 6.56967 -5353 4 36.1659 29.9908 36.1617 3.98829 10.9575 -2.82389 -5354 4 37.5905 29.761 35.5884 -25.1141 24.4323 0.251817 -5355 6 12.9563 4.31922 37.9158 -41.9162 -7.49401 17.923 -5356 4 12.213 3.67486 38.0016 27.2031 5.98064 4.05536 -5357 4 12.5797 5.11915 38.3509 20.8388 -3.72048 -10.4757 -5358 6 38.3368 5.25882 18.4553 -27.9454 13.7946 -11.1943 -5359 4 37.494 5.12162 18.8921 -4.17763 4.09508 -3.9191 -5360 4 38.9486 5.03087 19.1262 32.9808 -9.34357 19.7422 -5361 6 10.4991 9.23341 21.7308 -20.3579 1.12747 21.1104 -5362 4 10.1476 9.35811 22.629 -2.53412 -6.58654 -7.03761 -5363 4 11.4429 9.27697 21.8681 13.0367 -0.194449 -11.5952 -5364 6 0.510441 41.039 17.3204 -22.411 45.8537 -1.19125 -5365 4 1.10275 40.3438 17.515 21.9532 -27.5034 12.6219 -5366 4 0.955429 41.8901 17.5577 -0.403404 -22.4144 -8.21181 -5367 6 4.11028 5.06714 6.43108 -32.0559 -10.673 -25.0156 -5368 4 4.76196 4.43778 6.68194 21.2279 -22.0503 -6.17775 -5369 4 4.3376 5.79555 6.94869 8.69612 42.0455 26.6358 -5370 6 11.4527 25.4042 0.173069 -8.87291 20.1751 -4.43043 -5371 4 11.3037 26.302 0.51034 -2.48968 -2.12098 1.34892 -5372 4 12.3912 25.256 0.330533 -7.09022 -12.0676 2.67745 -5373 6 7.43008 21.5598 8.10589 6.84767 -16.7382 -30.018 -5374 4 7.67559 21.2373 7.18738 -12.1375 12.6211 33.8068 -5375 4 8.24892 21.8626 8.52003 -6.07298 -1.72571 -6.46698 -5376 6 47.5896 16.3642 25.2431 -28.5582 13.6976 -25.6498 -5377 4 46.6075 16.1608 25.1822 37.2389 5.55574 -4.66364 -5378 4 47.8562 16.8152 24.3682 -3.16196 -14.4146 40.515 -5379 6 30.9292 19.5125 39.8483 -41.4217 8.94898 -20.4144 -5380 4 31.859 19.4188 40.0164 22.9308 8.40553 1.58818 -5381 4 30.7224 20.3633 39.3589 16.5857 -27.3682 15.8932 -5382 6 20.3871 24.0387 39.4036 8.00795 23.2793 -8.75093 -5383 4 19.459 24.1701 39.2693 -20.2994 13.2523 2.58474 -5384 4 20.4244 23.1071 39.4874 5.50164 -36.2952 5.14995 -5385 6 45.8871 21.2471 41.1655 20.5283 25.7578 0.477301 -5386 4 46.6385 21.2626 41.7552 1.12624 -15.6366 20.1575 -5387 4 46.1812 21.9667 40.5962 -14.858 0.0662744 -14.6758 -5388 6 32.5732 28.1983 30.4559 17.8923 -19.7368 14.2663 -5389 4 32.9661 27.3096 30.6426 -14.7491 22.8943 -8.37245 -5390 4 33.2232 28.8091 30.8453 -8.57676 -1.81844 -4.53088 -5391 6 18.0207 1.32021 27.0363 -34.7874 1.53884 20.0911 -5392 4 17.0721 1.60205 27.1202 27.3864 -5.2263 -11.315 -5393 4 18.3294 1.50373 27.9381 11.4124 1.84961 -11.8648 -5394 6 39.378 24.9761 21.8758 -21.83 -3.15726 3.51608 -5395 4 39.2925 25.9351 21.9975 13.0773 -1.30024 -1.60914 -5396 4 38.5262 24.6687 22.2439 10.6836 3.42961 -4.87158 -5397 6 33.5904 21.3057 22.0908 0.876878 23.3779 1.34154 -5398 4 32.7037 21.4589 21.7601 -6.64994 -10.6299 -4.35651 -5399 4 34.0298 22.1428 21.8479 4.87062 -13.8873 3.79153 -5400 6 40.1162 15.0006 15.7553 -16.7667 -72.1851 -56.1125 -5401 4 39.3246 14.5665 15.2764 38.6699 22.9899 20.5541 -5402 4 39.7685 15.7046 16.224 -23.0828 51.553 35.6364 -5403 6 32.7063 17.9241 6.36312 -6.65812 28.0098 -27.693 -5404 4 32.6631 17.3286 7.08836 -4.96405 -26.2659 23.6138 -5405 4 32.2202 17.5402 5.61621 0.349997 -9.22032 2.43078 -5406 6 50.4717 15.9308 31.1336 -57.0185 -34.1342 43.3708 -5407 4 51.2677 16.1483 30.7347 55.5832 16.4654 -29.6643 -5408 4 50.5499 15.0059 31.4683 -2.42192 20.1529 -11.8828 -5409 6 23.8292 29.3322 31.6407 10.3974 -8.56959 5.42825 -5410 4 23.7096 29.6981 30.7618 4.3803 -0.813234 -2.10966 -5411 4 24.6813 28.8378 31.6594 -15.3785 13.3689 -4.34977 -5412 6 25.0524 41.6477 38.2806 4.00174 7.46449 -31.3583 -5413 4 25.6511 41.367 37.5454 -10.3054 -0.491554 23.0497 -5414 4 24.5276 0.474703 37.8884 8.98972 -6.87862 14.9811 -5415 6 14.3299 25.4693 7.99598 -51.8246 -23.5651 26.6357 -5416 4 15.0301 25.7523 7.4663 39.147 18.3395 -31.3738 -5417 4 13.6749 25.0466 7.38907 19.2382 9.49844 7.52052 -5418 6 17.2117 20.7467 5.34291 -12.6959 30.9635 29.5807 -5419 4 17.5658 20.2645 4.6512 13.3362 -42.6322 -45.6451 -5420 4 17.6752 21.5763 5.21476 -4.76461 12.1014 12.8322 -5421 6 18.8578 10.961 23.7113 11.9098 -52.6755 14.4862 -5422 4 18.5821 10.3312 23.0139 -2.7304 18.9854 0.947207 -5423 4 18.7069 11.8432 23.4586 -8.32501 34.3086 -18.4054 -5424 6 7.80658 41.3805 11.0401 -9.04392 11.0606 6.15122 -5425 4 8.00429 40.5098 11.4059 2.67644 4.01258 -4.23655 -5426 4 8.51691 0.066 11.3394 -1.81513 -7.16892 -1.05394 -5427 6 48.6966 23.1832 34.0648 -27.3561 -6.76338 -18.0805 -5428 4 48.0792 22.9132 33.32 19.6766 11.2437 24.8207 -5429 4 49.5669 23.23 33.6693 11.2336 0.854645 -6.12438 -5430 6 53.7246 23.5588 15.3422 -2.2993 4.88061 -38.5045 -5431 4 54.0115 23.9686 14.4981 1.04624 9.96871 20.6807 -5432 4 53.2132 22.8493 14.9574 -7.54922 -9.79714 16.7607 -5433 6 22.2409 5.63035 9.83732 -4.74687 0.990813 -28.4051 -5434 4 21.8007 4.9012 9.36518 5.41421 2.33681 17.3637 -5435 4 22.5704 6.16354 9.07597 -3.08255 -9.23766 25.1176 -5436 6 33.6677 8.38805 9.07277 4.65141 2.45263 2.68713 -5437 4 32.9476 8.96499 9.32099 -11.143 10.7473 10.4723 -5438 4 33.4213 8.08448 8.2012 2.38155 -0.0587928 -10.5973 -5439 6 47.3188 37.7205 20.3441 15.215 11.7573 -25.0114 -5440 4 47.5704 37.5879 19.4187 8.2864 3.06637 8.88956 -5441 4 46.6261 37.0853 20.3703 -21.7602 -22.9037 19.9419 -5442 6 30.8605 16.7391 10.6102 -28.0995 -48.2853 23.2284 -5443 4 30.4428 17.1675 11.4048 8.00556 -5.70758 -17.8294 -5444 4 30.5213 15.7576 10.5828 6.17084 54.1408 -3.58748 -5445 6 48.1227 27.723 10.1192 -17.271 38.6552 19.8549 -5446 4 48.941 27.5885 10.6019 15.4404 -6.10886 -7.64033 -5447 4 47.9667 27.1056 9.42146 1.69339 -23.2576 -13.9441 -5448 6 27.3465 38.6397 25.5972 -19.3603 -43.7567 25.3821 -5449 4 28.2552 38.3171 25.6348 3.73027 6.4174 -6.06634 -5450 4 27.3175 39.4354 25.1025 9.7616 28.5552 -11.1584 -5451 6 33.3485 5.72785 21.4502 -30.5322 15.1217 -10.2054 -5452 4 32.7106 6.21453 20.8566 24.3968 -18.0484 15.2917 -5453 4 34.2142 6.02589 21.2258 21.3261 10.3595 -12.9949 -5454 6 25.3097 5.14436 4.52462 -12.6707 -6.42781 10.7366 -5455 4 25.8166 5.03621 5.34324 9.24373 -0.000563512 -7.52253 -5456 4 24.4109 4.89546 4.80865 9.45245 1.955 -8.20101 -5457 6 40.4804 35.6472 19.1595 -4.18239 -17.2552 -25.1441 -5458 4 40.6473 35.1871 19.989 -0.677015 6.66802 10.9293 -5459 4 40.3876 36.5867 19.2889 2.08163 9.85771 9.62751 -5460 6 49.6466 30.6357 19.0258 14.8172 21.4531 -43.5404 -5461 4 50.0494 29.991 18.4245 -6.82309 -11.6442 2.45506 -5462 4 49.4912 30.1943 19.8303 -8.11919 -24.8089 39.0949 -5463 6 42.1414 28.3198 17.0336 30.9261 -8.96587 16.5499 -5464 4 41.9014 28.1134 16.1233 0.612516 -1.09878 -6.61247 -5465 4 42.9986 27.8356 17.2327 -32.0588 11.6021 -17.9905 -5466 6 47.7009 24.529 36.3602 12.6164 -10.6945 -29.4467 -5467 4 46.9511 23.9476 36.4057 -12.614 -6.01445 14.1932 -5468 4 48.02 24.3175 35.4647 6.89481 1.31964 6.68358 -5469 6 19.3487 26.9773 19.8132 -7.91098 29.1703 -3.69101 -5470 4 19.5772 26.0513 19.7652 -2.42994 -17.6971 2.90599 -5471 4 18.7132 27.1892 20.5145 5.94626 -13.5516 -3.80193 -5472 6 47.0594 26.8038 37.5124 29.171 -27.35 55.5912 -5473 4 46.5442 27.3901 37.0243 -28.7601 35.2651 -40.4696 -5474 4 47.4575 26.1126 36.9775 -8.83233 1.8809 -11.4479 -5475 6 9.306 24.6801 40.2841 31.4937 0.109789 0.329283 -5476 4 9.78189 23.9102 39.8717 -14.0424 16.7407 17.3327 -5477 4 10.0272 25.2082 40.7306 -19.6308 -16.1327 -14.1874 -5478 6 14.4855 17.9139 14.2735 23.8217 -2.3356 -5.96097 -5479 4 13.7756 18.1909 13.6871 -0.445295 3.10639 3.20472 -5480 4 15.2926 17.8532 13.6969 -24.9099 1.36359 15.4275 -5481 6 37.1333 38.6708 18.7289 9.24178 15.507 -32.6939 -5482 4 36.7257 39.5382 18.5851 -4.02817 -0.227247 6.07181 -5483 4 37.6697 38.5833 17.9067 -2.91955 -11.3843 16.172 -5484 6 11.4153 5.92336 21.4477 15.4675 -15.5323 24.3843 -5485 4 12.0347 5.46444 22.0611 -14.8481 11.1792 -11.8992 -5486 4 10.9828 5.22117 20.955 -5.02219 -4.37746 -7.57367 -5487 6 4.24672 30.7112 16.2271 25.0754 -37.7862 10.5022 -5488 4 4.05441 31.4608 15.7204 -4.71706 34.9582 -31.1175 -5489 4 3.72964 30.8334 16.9988 -11.892 -2.06994 24.4228 -5490 6 17.6689 16.0105 27.0706 -11.532 -19.4613 -16.5334 -5491 4 17.475 15.0322 27.0999 0.550485 29.0366 -12.0979 -5492 4 17.2014 16.3875 26.2691 10.8221 -16.0252 20.0561 -5493 6 36.4979 8.6445 40.4253 22.1182 5.90925 -1.87084 -5494 4 36.6649 9.56092 40.6574 -3.64727 2.10984 0.486612 -5495 4 35.6642 8.36755 40.7885 -12.5441 -1.64485 2.44437 -5496 6 13.6104 12.9476 3.01337 -0.796658 -1.76047 52.4558 -5497 4 13.281 12.534 3.85665 2.0295 3.09436 -35.1239 -5498 4 14.3672 13.4568 3.35498 1.79634 -1.71495 -16.7359 -5499 6 38.5663 20.1511 21.6276 16.2684 -2.59448 10.3838 -5500 4 39.225 20.3435 20.957 3.66548 0.723189 -1.42015 -5501 4 37.7399 20.1987 21.178 -26.4348 -4.9091 -11.1397 -5502 6 51.0002 10.2707 30.836 -20.0759 -41.5967 21.7358 -5503 4 51.4945 11.0341 30.626 15.2265 30.1997 -10.6067 -5504 4 50.365 10.1656 30.1217 2.42758 1.75416 -9.76943 -5505 6 16.2768 2.44039 41.3342 24.5898 23.894 -47.9169 -5506 4 15.7659 1.68969 41.4668 -26.4768 -52.1654 31.458 -5507 4 16.2309 2.46185 40.3616 9.12406 8.41144 7.6857 -5508 6 16.5823 4.96192 41.8916 -4.82165 52.2801 -70.6027 -5509 4 16.7504 4.9538 0.881833 10.2709 -3.72182 62.3109 -5510 4 16.3825 4.09214 41.6138 -6.48385 -26.7637 5.90228 -5511 6 38.2132 37.6512 20.9834 35.6931 -0.0015793 9.16781 -5512 4 38.1132 38.2158 20.1985 1.71026 -5.63736 5.42755 -5513 4 39.175 37.679 21.2752 -35.8773 5.52261 -11.9395 -5514 6 27.3063 1.90932 15.7743 -36.1781 7.04456 22.02 -5515 4 27.5288 1.21363 15.1745 3.62804 -9.29946 -19.0329 -5516 4 26.3092 1.89423 15.8276 27.8398 0.929522 -3.41863 -5517 6 29.0129 12.4346 37.8081 29.6396 -2.3639 23.3235 -5518 4 29.5703 13.228 37.8521 -9.25731 3.38449 -11.2245 -5519 4 29.432 11.8866 38.5178 -20.735 6.92768 -10.3763 -5520 6 46.0725 20.1624 18.9069 6.39102 14.9163 -14.6323 -5521 4 45.1723 20.516 18.8892 1.91785 -0.379773 0.405435 -5522 4 46.587 20.7656 18.3221 -3.54001 -13.7442 9.74416 -5523 6 2.03634 38.6845 18.4933 3.82981 -3.85695 21.6638 -5524 4 2.81563 38.6864 19.0472 23.4807 10.2435 -12.678 -5525 4 1.45125 38.3557 19.1766 -27.1945 -1.99387 -8.3623 -5526 6 44.0469 24.9707 25.966 7.80173 10.6441 20.9452 -5527 4 44.2747 24.0363 26.0952 1.37736 2.33249 -4.33209 -5528 4 43.5784 25.0701 25.1359 -3.49858 -7.6437 -6.59112 -5529 6 5.98346 26.6137 4.53144 23.0758 4.04073 24.4329 -5530 4 6.55391 27.1627 5.13089 -15.1794 -12.3526 -15.6845 -5531 4 6.29729 25.6938 4.67268 -13.7287 18.2257 -9.78447 -5532 6 0.087877 23.2081 10.934 24.9145 3.46447 1.10559 -5533 4 0.685292 23.7315 10.3726 -8.08066 -2.01306 3.92681 -5534 4 0.721975 22.7627 11.5282 -19.4067 -0.934622 -1.78644 -5535 6 39.1228 20.6282 12.8796 23.5823 -4.01912 3.74068 -5536 4 40.0483 20.9095 13.1274 -25.2182 -11.8294 -4.75086 -5537 4 38.9288 21.0058 12.0111 3.51405 8.21934 1.48951 -5538 6 39.9585 39.9542 18.8548 8.25477 7.63818 -34.14 -5539 4 39.6086 40.5348 18.1328 12.8912 -23.3113 16.3656 -5540 4 39.4227 40.1355 19.596 -22.4924 5.25798 25.9214 -5541 6 49.2764 23.011 30.5163 -3.77364 -44.6036 15.8547 -5542 4 49.4289 23.7872 30.0082 18.6126 30.182 -14.9565 -5543 4 49.9621 22.8706 31.1946 3.66181 18.5012 -4.70792 -5544 6 10.3518 2.34263 9.13761 -0.60969 70.0656 33.4022 -5545 4 10.2194 1.51752 8.76453 -19.3013 -48.5596 -30.1763 -5546 4 9.57958 2.95755 9.02478 16.8019 -18.7251 -1.57756 -5547 6 9.61453 40.9339 19.7468 19.8516 -54.9951 -16.0575 -5548 4 9.63195 40.6865 18.7859 0.317082 16.3896 20.6195 -5549 4 10.0376 40.0904 20.1458 -24.9194 43.0231 -10.2629 -5550 6 29.2525 5.10109 17.4961 7.67774 22.6856 2.90325 -5551 4 29.0408 4.77134 16.6193 -6.82779 -3.03985 -6.7526 -5552 4 29.5295 6.02934 17.3335 -2.58265 -16.5067 4.76001 -5553 6 27.0985 15.4102 3.23556 -13.4453 -81.1273 -7.3603 -5554 4 27.3652 16.2806 3.27349 18.8182 67.1491 11.283 -5555 4 27.7776 14.8512 3.68225 -14.3437 21.6428 -0.863725 -5556 6 32.8444 39.3852 25.121 -7.01244 -52.8845 44.4676 -5557 4 32.5131 40.2222 24.9368 -10.8075 51.8916 -16.2411 -5558 4 32.4445 39.2315 26.0289 16.1191 -0.874654 -30.671 -5559 6 34.9513 7.88207 31.2328 20.4504 58.5219 2.42802 -5560 4 34.2036 8.45679 31.498 3.65199 -12.2289 -1.35309 -5561 4 34.6861 6.99719 31.2488 -20.0023 -44.0519 1.25651 -5562 6 6.12467 36.7605 26.1486 23.5936 30.152 20.8626 -5563 4 6.61267 37.4751 26.6609 -18.7565 -29.2185 -15.3031 -5564 4 6.64666 36.6639 25.3566 0.873799 -8.15108 -9.63468 -5565 6 6.01736 25.8242 24.1032 -23.71 11.4997 43.6127 -5566 4 6.27054 25.4519 24.9889 5.69321 0.899098 -34.3464 -5567 4 5.25039 26.3671 24.4036 11.002 -12.3451 -22.9516 -5568 6 45.616 24.3868 2.54557 6.93899 11.9467 -1.18645 -5569 4 46.5025 24.2318 2.18535 0.269069 -11.0786 2.08994 -5570 4 45.6283 24.2142 3.48441 5.93067 -6.10702 12.3332 -5571 6 15.5106 11.7053 32.6869 22.7313 15.5035 25.4621 -5572 4 15.7644 12.551 33.1413 -9.31293 -24.2108 -12.4541 -5573 4 14.956 11.9719 31.9681 -12.2379 8.7831 -14.7046 -5574 6 46.4141 17.7037 37.4783 -24.8433 -42.9552 -46.1347 -5575 4 46.5841 17.8832 38.3706 6.4658 9.03355 44.3658 -5576 4 46.0203 16.778 37.4148 6.08678 36.5836 2.96135 -5577 6 39.713 20.917 18.528 13.2313 30.5311 40.8197 -5578 4 40.433 20.5782 18.0298 13.2747 -18.0123 -24.5712 -5579 4 40.2054 21.5165 19.1543 -30.2447 -12.7963 -15.6911 -5580 6 23.8051 28.0334 36.6648 -18.7533 17.1228 48.8478 -5581 4 23.301 27.37 37.1661 8.15196 -5.41595 -20.5023 -5582 4 23.699 28.7533 37.3439 14.557 -4.10395 -29.4534 -5583 6 23.235 0.659798 30.8906 16.7198 -34.3804 0.301059 -5584 4 23.3562 41.8891 31.5781 -2.93034 5.1259 -1.85649 -5585 4 23.9222 0.433479 30.2226 -16.4688 10.6885 3.12481 -5586 6 37.1438 6.89027 28.2945 -2.75708 2.50278 32.0481 -5587 4 36.7625 6.23385 28.9496 14.7229 22.3106 -21.8828 -5588 4 37.4874 7.65333 28.8474 -13.0775 -21.14 -18.6628 -5589 6 3.23769 6.61111 12.3846 0.723209 -17.9385 -9.61551 -5590 4 2.93962 6.7917 11.4726 6.04883 11.0603 10.3219 -5591 4 3.59705 5.70622 12.3141 -7.8292 10.6871 9.81534 -5592 6 12.6213 19.1513 31.1215 -11.7593 -39.2703 -9.13055 -5593 4 12.5689 18.1911 31.4279 4.41954 36.1073 -0.401864 -5594 4 12.3049 19.0952 30.1995 4.23471 8.33584 13.9505 -5595 6 15.1895 38.3194 41.5508 -8.26313 0.106571 5.96729 -5596 4 15.4027 38.685 40.6867 1.58925 3.7734 1.08261 -5597 4 15.977 37.8419 41.8199 8.82113 -1.67422 -0.112624 -5598 6 49.6344 33.3417 19.6414 -43.1776 -42.2962 -0.847743 -5599 4 48.6794 33.3996 19.9697 35.2792 3.84356 -17.7841 -5600 4 49.66 32.3974 19.2778 11.8172 40.1309 17.1575 -5601 6 6.36572 2.78375 29.9004 1.05055 15.8156 -22.8281 -5602 4 6.36575 3.75042 29.7262 1.90425 -15.9719 7.25575 -5603 4 5.96593 2.68858 30.7619 0.24665 -4.47807 16.8647 -5604 6 13.1696 31.768 30.2754 -6.44409 10.1839 -14.6274 -5605 4 12.7931 32.0108 29.386 8.00869 -8.49993 19.6421 -5606 4 12.9985 30.8211 30.4317 -1.17466 7.15103 -3.10169 -5607 6 32.315 32.2433 24.9103 28.3535 -13.0924 -48.465 -5608 4 32.6582 31.5201 24.3183 -18.8106 4.4732 28.5514 -5609 4 32.6906 33.004 24.4312 -3.21058 9.63112 20.1287 -5610 6 42.0003 14.5628 37.421 -39.889 12.6212 -8.37855 -5611 4 41.095 14.1415 37.3281 37.9102 -1.96214 -0.320241 -5612 4 42.7025 13.9066 37.3517 -4.02931 -15.6388 2.60245 -5613 6 11.8892 7.23447 27.6701 3.45884 -4.12236 4.5236 -5614 4 11.8415 6.40302 28.2109 -4.80024 17.2153 -14.4092 -5615 4 11.297 7.16355 26.8983 -0.411327 -9.99206 8.34553 -5616 6 14.2054 37.5349 6.88535 -5.50304 -50.1586 -23.8091 -5617 4 14.4448 38.4425 6.82842 11.1201 34.2121 -5.16838 -5618 4 14.5404 37.0855 6.04727 -8.45912 19.5264 31.302 -5619 6 14.2389 30.7101 36.0658 7.9951 22.3707 -6.00421 -5620 4 14.3369 30.7582 35.119 5.20948 5.89711 -15.5268 -5621 4 14.162 29.7856 36.1796 -2.50712 -40.828 17.27 -5622 6 16.4199 33.6465 5.49971 39.8982 -12.4718 -37.0106 -5623 4 16.8881 34.472 5.38053 -10.1033 13.7438 12.8324 -5624 4 16.9383 33.116 4.82328 -31.4907 -2.1142 22.2677 -5625 6 23.0347 17.1509 7.84843 -2.98061 53.305 10.417 -5626 4 22.2528 17.4913 7.37616 0.35347 -20.1342 1.7373 -5627 4 23.3535 18.0122 8.2624 2.91922 -40.8936 -9.01863 -5628 6 51.739 20.8998 27.7117 45.1346 -9.91933 19.8422 -5629 4 51.4539 20.5938 28.5983 0.576611 5.87017 -14.8878 -5630 4 52.7517 20.9693 27.7878 -43.3794 -0.870523 -11.1135 -5631 6 2.19386 27.6013 28.8077 21.9852 1.77593 -20.6905 -5632 4 2.90112 28.2633 28.7865 -8.94698 7.25322 21.5481 -5633 4 2.57794 26.9939 28.1568 -21.2327 -10.3447 8.82052 -5634 6 17.2209 14.3445 7.70498 -9.6153 -40.0176 25.3709 -5635 4 16.7414 14.2178 8.5755 19.2823 5.01031 -25.0594 -5636 4 17.7242 13.4894 7.54274 -12.7499 32.9606 1.11211 -5637 6 12.4553 8.94194 14.7093 23.4905 -30.5738 22.1451 -5638 4 12.3295 7.96561 14.6517 -10.6336 18.1935 -14.5798 -5639 4 13.0902 8.95069 15.466 -13.8235 22.031 -14.7981 -5640 6 42.4163 38.0607 9.75492 -41.3892 12.3524 0.930734 -5641 4 43.2155 37.8504 10.1985 23.5031 -2.65638 19.8551 -5642 4 41.8128 38.5249 10.3845 19.1619 -5.0707 -9.72644 -5643 6 51.8291 30.3524 28.2725 -23.4976 -15.3182 24.0858 -5644 4 51.4769 31.1806 28.0071 -16.9091 20.9854 -6.54852 -5645 4 52.5669 30.2698 27.7075 37.0459 -10.0857 -13.876 -5646 6 0.173291 18.5306 4.58887 -6.78508 26.3933 6.63194 -5647 4 0.366643 18.0957 3.77581 2.61413 -8.62723 -27.1515 -5648 4 0.528197 17.9664 5.25604 0.668563 -20.2899 17.5992 -5649 6 34.1542 0.618182 3.01035 -64.6642 7.59467 -29.5426 -5650 4 33.2756 0.91071 2.55681 38.9521 -14.8268 28.0312 -5651 4 34.8139 1.0189 2.46529 20.392 14.9436 -5.19898 -5652 6 49.1703 17.2445 23.163 11.3421 -28.7232 -23.3687 -5653 4 50.0948 17.5226 22.997 -11.4987 -1.8789 7.34388 -5654 4 49.1149 16.3391 22.7575 3.35316 27.0342 8.27414 -5655 6 23.1508 6.50484 23.6205 15.3745 23.1125 -33.0506 -5656 4 23.1854 7.14565 22.8174 -14.1016 -25.0292 28.8988 -5657 4 22.2566 6.27815 23.8868 -11.3625 11.3028 -1.57795 -5658 6 11.0777 24.0866 29.2726 3.42799 -14.5151 -26.2344 -5659 4 11.3051 23.4915 28.5104 -10.7193 12.1306 15.2701 -5660 4 11.7189 23.8646 29.9475 6.00027 1.59973 10.1126 -5661 6 36.5499 4.08922 21.6769 -9.80126 5.87302 -21.3361 -5662 4 36.3976 4.50823 22.521 3.21878 -0.144303 13.033 -5663 4 36.3054 4.80832 21.0596 6.63301 -13.9203 1.83546 -5664 6 31.3023 25.6432 24.5943 15.0376 6.85795 28.0728 -5665 4 31.291 26.2789 25.3519 -12.6017 -14.5788 -25.478 -5666 4 32.0941 25.1064 24.7955 -9.59576 -0.449362 -7.93794 -5667 6 42.6065 23.029 14.7662 -46.2562 -12.0705 -53.1337 -5668 4 42.8654 23.3474 13.8766 8.33796 6.77145 13.2285 -5669 4 43.1929 23.285 15.4255 44.8404 21.8098 38.991 -5670 6 14.3111 11.6689 8.88632 -19.0153 -23.9468 -21.906 -5671 4 13.3495 11.3817 8.87766 31.9146 14.5471 0.24728 -5672 4 14.742 11.0378 8.25313 -7.14597 12.5116 20.7778 -5673 6 21.4992 2.13393 3.40246 8.36864 -2.88126 -9.61958 -5674 4 22.4231 2.22963 3.69686 -12.58 -3.45743 -2.69439 -5675 4 21.4721 1.34946 2.81138 2.62282 6.56171 18.4043 -5676 6 22.4667 27.6841 39.0793 -16.1771 -11.2193 -33.3168 -5677 4 22.9487 28.2311 39.6723 13.8114 13.1168 21.0188 -5678 4 22.2331 26.8853 39.529 -0.753476 -8.75647 11.2468 -5679 6 37.2752 33.5075 30.0534 -5.09816 -29.8969 21.2662 -5680 4 36.5321 32.9121 30.2938 11.1992 13.6878 -5.37502 -5681 4 38.0391 33.1092 30.5204 -9.59535 7.6329 -11.7718 -5682 6 41.8356 20.8755 40.0084 -30.1785 -26.2846 -15.3963 -5683 4 40.891 20.6843 40.2338 21.7839 7.55089 -6.55796 -5684 4 42.213 21.2736 40.7728 12.4306 8.07023 23.0746 -5685 6 10.0585 31.1051 22.2503 24.8691 -18.1602 32.094 -5686 4 10.0242 30.9652 23.2199 -0.323131 -4.21186 -18.2592 -5687 4 9.26251 31.5457 22.0526 -32.5358 14.9165 -12.561 -5688 6 24.2061 35.3797 6.65176 29.8647 -7.74501 -52.0461 -5689 4 23.2981 35.13 6.46942 -12.5131 3.59528 11.7489 -5690 4 24.436 35.6291 7.5325 -13.5066 3.92126 26.0938 -5691 6 54.2205 13.3707 18.7548 -14.8606 0.23157 2.49876 -5692 4 53.5905 13.2954 18.0026 12.0308 5.79113 16.3195 -5693 4 53.7072 13.5032 19.578 4.97112 -2.65932 -16.1217 -5694 6 12.4895 25.0856 17.4479 -5.54126 21.12 19.6166 -5695 4 12.0527 25.8035 17.9613 1.96295 -15.4272 -10.9144 -5696 4 12.9797 24.5872 18.1192 -7.22993 -2.38631 -13.5888 -5697 6 22.3914 33.9622 18.8899 -17.7941 -3.8788 -25.186 -5698 4 22.7777 34.3519 18.0802 1.20341 3.55679 12.7761 -5699 4 21.5828 33.5138 18.532 26.0363 5.82114 13.25 -5700 6 24.4442 12.917 5.83205 -1.35281 -9.13891 6.68087 -5701 4 24.5112 13.8355 6.04562 11.139 23.8521 5.95609 -5702 4 23.7978 12.9208 5.12829 -4.38592 -8.75699 -5.70796 -5703 6 13.4045 11.2384 28.602 -9.94106 -32.5269 -0.345522 -5704 4 13.7125 10.4202 28.1467 1.06973 22.7078 1.68844 -5705 4 12.6883 10.856 29.1417 2.50959 12.0169 -5.49025 -5706 6 20.9681 34.6931 21.1354 15.1203 14.42 -6.16036 -5707 4 21.5009 35.1121 21.8248 -8.94458 -7.77672 4.1779 -5708 4 21.5063 34.8208 20.3262 -11.2236 -10.4562 8.09593 -5709 6 37.1336 34.5207 26.1541 -9.5297 -36.7224 -3.07541 -5710 4 37.2109 34.2142 25.2288 3.21082 15.1766 11.7274 -5711 4 37.5352 35.3664 26.2639 8.9577 18.3348 -6.65469 -5712 6 49.3622 27.1182 23.4746 39.7066 -11.0301 13.9767 -5713 4 48.4746 27.3502 23.3119 -43.65 9.96054 -8.06751 -5714 4 49.6716 26.7458 22.6451 -3.30563 -9.15784 -7.68388 -5715 6 2.6564 41.733 27.6477 -1.65257 -10.3676 0.180548 -5716 4 2.5349 41.5868 26.6785 2.71482 14.5166 10.808 -5717 4 3.44733 0.360291 27.8573 -13.8821 -2.9337 -13.5775 -5718 6 28.2538 5.65865 0.855763 -50.2522 -11.1502 7.99105 -5719 4 29.1126 5.92525 0.635025 43.8938 8.11388 -11.2713 -5720 4 28.2366 4.68907 0.832778 5.05155 4.08711 2.73992 -5721 6 46.3376 19.9476 30.6448 -5.32264 7.02196 22.3264 -5722 4 46.9473 19.8004 29.9179 3.84913 9.17517 -5.42643 -5723 4 46.6125 20.7672 31.1318 -5.12963 -19.3092 -16.4827 -5724 6 3.64577 25.7701 21.5553 -12.766 27.4814 -12.397 -5725 4 3.72382 24.8593 21.8343 3.84868 -9.88757 -5.52558 -5726 4 3.13913 25.8588 20.7173 13.2009 -15.3518 9.10855 -5727 6 2.75122 19.0968 29.6319 -2.61118 -0.882922 8.96218 -5728 4 3.5891 18.6871 29.8565 3.14038 -9.81989 10.1431 -5729 4 2.90737 19.4327 28.7602 3.1882 14.1904 -12.7773 -5730 6 11.8953 35.7778 24.2646 -23.8517 23.4638 0.926703 -5731 4 12.2722 34.9198 24.2954 23.5909 -23.1933 0.784725 -5732 4 12.5229 36.3761 23.8548 12.2449 3.68762 -3.83655 -5733 6 52.3409 30.3775 14.3038 25.9342 24.3497 3.27132 -5734 4 52.8186 31.1218 14.7277 1.28259 -10.3571 -1.87569 -5735 4 51.5459 30.7912 14.0165 -25.7225 7.74731 -5.34623 -5736 6 0.083662 24.3704 32.1159 7.87696 -1.86575 0.949534 -5737 4 0.925887 24.7254 31.8116 -7.58302 1.2158 -10.0766 -5738 4 0.064605 24.6797 33.0182 -11.6947 5.89195 12.8097 -5739 6 31.4941 23.7355 38.8139 13.6067 4.55671 22.3988 -5740 4 31.5922 23.3599 39.6955 6.6148 17.5079 8.63317 -5741 4 30.9989 23.0266 38.4646 -21.4094 -18.5611 -29.2329 -5742 6 52.1193 21.6104 3.49599 14.6151 -31.0847 -13.388 -5743 4 52.9641 21.5934 2.99085 -20.8635 4.42776 5.19501 -5744 4 52.1025 22.4297 3.95509 1.85636 27.8943 8.87727 -5745 6 31.7523 33.9412 11.6017 9.59211 -24.6365 -8.99112 -5746 4 31.343 34.2459 12.4067 -7.95657 10.1636 10.9534 -5747 4 32.0734 33.0348 11.7994 -4.73133 20.193 -2.42319 -5748 6 7.03486 17.6719 16.6685 29.0057 -41.5114 -49.367 -5749 4 6.91092 17.0215 17.3537 -7.78637 4.64801 28.8113 -5750 4 7.29826 17.0034 15.9319 -18.9591 50.1453 28.7374 -5751 6 51.8542 41.8728 22.1898 10.246 17.2442 -13.5357 -5752 4 52.3028 41.4443 22.9054 19.3182 -6.61148 18.5368 -5753 4 51.1068 41.3135 22.0792 -27.0964 -11.4612 -2.03348 -5754 6 50.8737 9.93347 25.9376 -32.929 -21.31 0.307119 -5755 4 50.6075 10.0984 25.0351 -2.54905 2.45869 -5.94774 -5756 4 51.7134 10.3221 26.0527 29.2363 20.0336 5.9403 -5757 6 9.00178 39.8723 13.8451 -19.3622 -18.1235 -30.983 -5758 4 9.55792 39.3182 14.3856 9.60602 -5.37935 8.26515 -5759 4 8.70771 39.29 13.0873 14.4347 20.6992 23.854 -5760 6 40.6986 25.5526 0.136544 19.9096 -17.3535 33.0343 -5761 4 40.3666 25.3638 1.04053 0.834228 7.76146 -13.9079 -5762 4 41.6521 25.7245 0.296606 -16.7956 -8.725 -14.7957 -5763 6 46.6823 7.83196 22.8561 10.1499 25.8504 33.9562 -5764 4 46.2788 7.49308 23.6743 -2.78909 -8.0392 -13.1915 -5765 4 47.099 8.65892 23.1926 -4.50937 -8.82075 -14.1875 -5766 6 20.9875 12.9068 9.95805 -11.691 32.2034 24.7109 -5767 4 21.4351 12.3054 10.5167 21.854 -26.8991 22.1196 -5768 4 21.3309 12.7465 9.11062 12.4417 -9.66517 -44.3579 -5769 6 24.8453 0.514421 28.6038 13.082 22.7197 -2.81433 -5770 4 24.715 0.071792 27.7548 -6.16819 -1.63374 -2.91335 -5771 4 25.0442 1.45997 28.4028 -6.72102 -19.281 3.08734 -5772 6 9.94041 22.6855 8.28517 -18.2906 18.759 -35.6321 -5773 4 10.3442 21.9586 7.83344 17.071 -18.1108 1.7387 -5774 4 9.60436 23.1702 7.48056 7.13277 7.40532 33.7222 -5775 6 33.2759 9.25429 23.8257 8.37106 -55.2845 13.9355 -5776 4 33.3237 10.1123 23.4806 -1.26345 47.1757 -20.4798 -5777 4 34.1087 8.81977 23.5578 -8.47821 6.16632 5.2483 -5778 6 47.7984 20.3614 34.2959 -41.6158 20.0741 -32.6301 -5779 4 47.162 20.9095 33.7523 35.4977 -6.5354 18.8426 -5780 4 47.2264 19.5923 34.4121 13.8381 -6.37745 11.1074 -5781 6 7.49292 13.4971 41.09 9.79805 -11.8131 -23.6679 -5782 4 7.49901 13.1324 40.1715 -6.0705 12.8605 17.5951 -5783 4 8.32745 13.1637 41.4633 -5.36906 3.36653 2.36319 -5784 6 9.96112 23.6102 1.61114 1.89646 0.256416 -8.05524 -5785 4 10.3422 24.1467 0.893187 3.70522 0.0162214 12.766 -5786 4 9.63217 22.8308 1.16111 -2.5861 -8.4474 -3.4617 -5787 6 27.3279 14.1675 11.3384 -16.3978 3.93745 18.7515 -5788 4 27.0565 14.7974 10.6584 -0.154384 0.736593 1.51299 -5789 4 26.9739 14.5213 12.1957 15.9081 -3.44829 -24.7787 -5790 6 25.8416 31.7729 17.8867 -18.6075 -57.137 -13.4601 -5791 4 26.5498 31.1652 17.5816 -7.88637 19.42 8.67928 -5792 4 26.1364 32.6121 18.1157 31.0786 47.9057 11.8145 -5793 6 28.5054 34.3394 0.220618 54.67 33.5077 11.5224 -5794 4 29.0324 33.8757 0.885908 -4.94848 -3.20805 0.921423 -5795 4 27.711 33.8992 0.092994 -46.8158 -31.9819 -6.78258 -5796 6 39.4821 27.6754 22.7241 37.6977 26.8974 -34.7457 -5797 4 38.562 27.8477 22.7631 -35.1425 8.51836 6.28403 -5798 4 39.8483 28.4606 22.2037 -4.4779 -30.5719 17.4824 -5799 6 19.3989 35.5068 37.6449 44.7238 7.00696 26.241 -5800 4 18.7939 34.9286 37.217 -17.2642 -20.3375 -13.2178 -5801 4 20.0787 34.9056 38.0699 -27.4009 15.1777 -18.4057 -5802 6 40.2622 30.2205 10.7395 23.7464 -4.20556 -44.2191 -5803 4 39.872 30.2327 11.5724 -12.5687 -7.32393 56.9787 -5804 4 39.6265 30.6987 10.2193 -5.46151 14.1383 -16.826 -5805 6 44.8252 28.4803 36.0885 -55.5401 -40.4399 48.4955 -5806 4 44.0914 27.9458 36.6324 49.8455 26.3412 -39.6007 -5807 4 44.7386 29.3482 36.4954 11.2485 4.05282 -13.3799 -5808 6 17.9305 13.9374 34.278 5.37655 43.1893 -39.9004 -5809 4 17.3503 14.7126 34.0365 12.4853 -29.216 13.3111 -5810 4 17.5732 13.4499 34.9957 -23.6035 -11.4222 25.4792 -5811 6 22.772 11.7897 25.9182 -5.92321 66.9234 -24.4623 -5812 4 22.4079 10.9608 26.1065 -2.80798 -46.2844 14.8143 -5813 4 23.7282 11.8442 25.9391 13.2658 -20.917 3.34216 -5814 6 27.9678 31.9745 40.3581 9.67064 -3.036 11.5355 -5815 4 28.3415 32.7469 39.952 3.83939 12.9153 -6.44865 -5816 4 27.8423 31.3481 39.6454 -9.64166 -7.41544 0.62615 -5817 6 29.7189 5.14175 29.7003 46.1252 -36.6163 -19.9261 -5818 4 29.2969 5.47215 30.4671 -15.8461 16.6952 32.1509 -5819 4 30.5834 4.69597 30.0017 -39.473 23.5261 -13.8417 -5820 6 3.10812 21.482 2.76797 0.178067 -30.2305 -7.76436 -5821 4 2.88389 22.394 2.68207 -8.68283 21.8462 0.431797 -5822 4 2.52465 20.9987 2.15107 4.11904 7.00085 10.9335 -5823 6 13.6455 30.6616 39.7413 -31.0251 6.24286 -53.6991 -5824 4 14.4958 30.9276 39.9901 40.59 7.52955 18.7737 -5825 4 13.6028 30.9637 38.7781 -13.7388 -14.6365 40.9566 -5826 6 39.1879 23.0833 28.2631 23.8153 34.0131 -40.8644 -5827 4 39.3603 23.1915 27.276 -9.32936 -4.03115 31.7012 -5828 4 38.6771 22.3028 28.3825 -19.3689 -24.2853 3.44718 -5829 6 16.9942 23.7475 0.782551 23.2332 -11.0525 -6.02825 -5830 4 16.1835 23.4907 1.22514 -0.204047 -3.07314 3.44284 -5831 4 17.6924 23.1245 1.11262 -18.9135 18.2649 -2.71213 -5832 6 0.34625 33.6655 13.0265 -29.0282 32.855 38.2597 -5833 4 54.9333 33.1158 13.7076 7.16186 -20.0974 -8.4449 -5834 4 0.196186 34.5312 13.5136 21.864 -23.0202 -35.8666 -5835 6 49.1134 40.6592 16.9502 -22.6074 7.13526 -12.7963 -5836 4 49.0929 41.0585 16.0481 9.95068 -10.3513 11.1088 -5837 4 48.1763 40.6949 17.2078 7.5264 3.31219 -3.37923 -5838 6 52.1371 39.9932 15.179 23.5783 8.13152 6.60826 -5839 4 51.9212 40.0798 16.1068 2.92809 -1.65288 7.91558 -5840 4 51.3496 39.6649 14.7978 -27.1925 -6.99882 -20.2103 -5841 6 29.0492 37.0934 37.8397 27.862 0.580994 -15.5106 -5842 4 29.7824 36.6456 38.29 -13.83 -0.942856 -3.03347 -5843 4 28.3401 37.1923 38.4583 -14.8343 8.34268 17.6028 -5844 6 4.87483 1.47389 27.5722 8.99005 1.78018 0.412076 -5845 4 5.18955 1.04652 26.7639 -2.94161 4.65408 6.15856 -5846 4 5.65876 1.67721 28.1054 -5.69693 -0.488114 1.02013 -5847 6 43.5905 24.3648 30.2005 -22.2044 -15.6763 19.9702 -5848 4 44.3573 23.9419 29.8442 19.8319 -9.6252 -11.3654 -5849 4 42.9995 23.6287 30.4468 4.54232 11.3491 -5.57307 -5850 6 33.7546 3.53169 22.9281 6.20171 -10.3572 -20.5792 -5851 4 34.1788 2.72522 22.5548 -7.61164 22.2296 6.95503 -5852 4 33.66 4.19918 22.2026 -0.715781 -19.232 19.3758 -5853 6 19.8847 13.4579 25.4063 -13.0952 -9.58357 -31.6265 -5854 4 20.5464 14.0819 25.6574 14.0517 10.8301 14.4774 -5855 4 19.8633 12.7253 26.0209 8.35596 -5.88238 10.9252 -5856 6 47.3765 23.175 39.6238 -8.62258 12.6683 8.16714 -5857 4 47.7656 22.5263 39.0394 4.03481 -11.1372 -12.2265 -5858 4 47.7314 24.026 39.3382 2.38196 -1.35255 2.76448 -5859 6 20.1792 18.6695 32.3892 10.8118 -11.8558 9.82813 -5860 4 19.7451 19.3837 31.9609 -18.6549 15.8768 -14.4176 -5861 4 21.1063 18.8885 32.2904 5.57481 -8.22146 4.6255 -5862 6 0.469489 5.80056 25.6694 -18.1951 25.8664 -34.3154 -5863 4 0.192512 6.63022 25.2132 12.4788 -26.9708 -4.90825 -5864 4 0.599388 6.15564 26.5295 8.98284 3.20038 34.2611 -5865 6 6.87796 19.5502 31.9212 -30.9469 28.3562 -15.4034 -5866 4 6.36899 19.9719 32.666 7.94508 -11.3044 -26.1662 -5867 4 6.51823 19.9652 31.058 21.1032 -17.2362 32.6466 -5868 6 6.72006 20.2763 38.5282 -5.5716 11.964 -18.9783 -5869 4 5.89143 20.7831 38.5761 11.8801 -4.42879 -4.55199 -5870 4 6.91977 20.0675 39.4366 -2.33705 -6.77268 4.9945 -5871 6 22.0131 25.9408 12.2669 -3.54377 -45.9259 -44.7125 -5872 4 21.4169 25.4251 11.6232 6.06411 36.0021 36.1209 -5873 4 22.8575 25.5519 12.0003 5.79029 4.70211 8.19546 -5874 6 39.2956 7.94468 2.64777 3.93347 -3.54621 1.69719 -5875 4 39.6192 7.96721 3.55942 2.89932 9.4301 1.57912 -5876 4 39.5223 7.0665 2.33247 5.57505 -8.53159 -3.65477 -5877 6 29.9733 22.0379 34.4029 6.80249 8.99144 -26.5663 -5878 4 30.9486 21.9114 34.4332 -22.6925 2.47334 -4.63229 -5879 4 29.7282 22.2324 33.4511 1.23467 -5.29722 31.1857 -5880 6 37.585 16.2896 0.378862 9.66072 -32.1652 -13.4334 -5881 4 37.1738 15.3958 0.469359 7.4986 19.6703 2.82788 -5882 4 38.3979 16.0784 41.7811 -5.81955 5.34443 7.8674 -5883 6 11.7199 13.8969 21.9024 0.976022 -4.28814 -52.9061 -5884 4 11.762 13.5091 20.9636 8.25344 3.74313 41.2159 -5885 4 11.7301 13.2111 22.5694 -0.197866 -18.3587 0.721586 -5886 6 33.3547 10.9227 27.6206 7.79028 2.98821 -12.2755 -5887 4 32.7398 11.5851 27.2614 8.9286 -8.03905 3.2582 -5888 4 34.0693 10.7866 26.9485 -19.1033 10.7299 13.3482 -5889 6 30.9479 36.5351 10.0985 1.61282 -58.9885 -21.8283 -5890 4 31.0506 36.3975 9.1055 -4.33965 11.8991 35.1417 -5891 4 31.0192 35.5887 10.4601 -6.41155 39.3119 -7.26857 -5892 6 45.5784 6.55949 25.24 49.1938 -13.828 -6.30557 -5893 4 44.6777 6.5515 25.5065 -25.461 -8.09624 7.65514 -5894 4 45.978 5.64009 25.2752 -26.9592 28.1751 -0.0529727 -5895 6 9.53089 30.0259 12.0468 18.203 -29.4993 -35.3826 -5896 4 9.87965 30.5113 11.2809 1.8895 2.86193 6.03312 -5897 4 9.26134 30.6784 12.652 -18.7794 25.6859 27.1844 -5898 6 53.0787 24.9761 1.37462 5.70131 11.5656 52.3682 -5899 4 52.7701 24.171 1.02302 -14.9871 -27.078 -25.8882 -5900 4 53.2426 25.5756 0.676612 4.18045 17.0305 -26.7636 -5901 6 26.1794 24.7359 0.502901 22.1176 -25.6344 -30.1555 -5902 4 25.7034 24.7594 41.5454 1.42755 5.35042 26.0986 -5903 4 25.8798 25.3805 1.12222 -18.0425 21.9232 11.274 -5904 6 23.006 2.41877 11.549 3.03835 0.786733 -23.201 -5905 4 22.1232 2.19651 11.8728 1.75899 -1.65202 1.96434 -5906 4 22.9163 2.42328 10.5701 -3.31062 2.24291 13.1011 -5907 6 29.9286 12.8953 30.9894 2.56623 -0.427284 6.89615 -5908 4 30.7531 12.7948 31.5295 -11.6926 9.48208 -25.7239 -5909 4 30.1452 13.1242 30.0532 3.97045 -7.90132 21.6369 -5910 6 24.0654 16.1863 40.3478 -8.57837 -16.1993 -7.0618 -5911 4 23.8181 16.8167 40.9886 -17.7345 17.1107 43.7161 -5912 4 24.4461 16.799 39.7307 8.03288 -6.21636 -19.956 -5913 6 21.8775 29.9129 12.7438 8.38993 20.3936 0.69825 -5914 4 21.1101 29.6022 12.2761 -16.411 -9.00989 -4.05561 -5915 4 21.7959 30.8814 12.6689 6.66677 -10.3308 5.74649 -5916 6 45.2196 12.276 6.62528 -23.2047 44.1078 30.1736 -5917 4 45.4494 11.529 6.11864 16.0879 -27.9404 -20.133 -5918 4 45.9267 12.944 6.63915 -2.18395 -9.27911 -10.7446 -5919 6 7.59043 25.3914 38.0243 42.7544 -18.087 21.3587 -5920 4 8.2454 25.1294 37.3073 -28.6085 13.3538 22.5553 -5921 4 8.06078 25.1795 38.9036 -17.5445 13.8955 -36.9473 -5922 6 46.1702 7.81994 16.6869 -21.8749 40.0263 -11.2018 -5923 4 46.5308 7.86296 15.7811 2.96678 -6.7279 9.6444 -5924 4 46.6568 7.20863 17.2067 24.29 -27.7199 6.2944 -5925 6 54.9712 12.8519 7.72645 -5.0392 -7.84126 -11.592 -5926 4 54.9715 13.8156 7.65436 -3.45199 -1.13943 9.08655 -5927 4 54.3111 12.5688 8.37934 8.51313 12.0297 -0.864167 -5928 6 26.936 39.6495 37.1759 1.87165 14.912 18.6021 -5929 4 27.6928 39.6002 36.5592 -3.34619 -10.0228 14.3716 -5930 4 27.1866 39.3914 38.108 -0.832196 -0.678219 -33.4669 -5931 6 27.0349 8.92218 38.0169 24.6524 -2.61622 -28.7715 -5932 4 26.316 9.52058 38.1337 -23.9094 17.4181 8.51603 -5933 4 27.4852 9.31616 37.2255 -4.7843 -14.0734 18.554 -5934 6 8.05135 7.65161 29.9116 12.1299 -7.94147 21.2544 -5935 4 8.62851 7.92802 30.6495 -6.35395 -5.29094 -12.0163 -5936 4 7.74814 8.47335 29.5547 -5.2558 18.4649 -14.2469 -5937 6 27.8737 27.8565 12.1051 -38.6038 15.3188 22.9885 -5938 4 27.4445 28.7122 12.3849 14.7215 -19.9621 -4.23437 -5939 4 28.6312 28.0341 11.5799 28.6137 10.9177 -18.1106 -5940 6 23.5548 30.5037 38.1558 -29.4871 -31.9475 26.5081 -5941 4 24.0962 30.758 38.9126 3.93335 7.76671 -5.43794 -5942 4 23.9417 30.8351 37.3772 21.2145 16.4773 -23.4003 -5943 6 48.0793 24.306 17.3344 -19.3615 12.8085 -14.3801 -5944 4 47.2872 24.7421 17.7455 27.359 -7.68532 -3.4425 -5945 4 48.1537 24.7387 16.4546 -0.580236 -6.90317 13.1114 -5946 6 38.498 5.30294 40.3305 40.7021 23.5094 2.62433 -5947 4 38.9475 4.64687 39.7972 -10.9193 -18.4764 2.07144 -5948 4 39.1882 6.01706 40.3225 -28.8653 -3.92995 8.38836 -5949 6 31.2337 3.92695 33.7301 -2.6422 16.6026 -6.87478 -5950 4 31.7948 4.28658 33.0166 -2.97898 -8.44373 7.32517 -5951 4 31.5298 3.03423 33.9266 10.3473 -9.06319 -0.444766 -5952 6 41.2426 8.81864 38.1104 -4.47266 -7.82466 24.3448 -5953 4 41.0373 8.41451 38.9755 -2.01902 1.52645 -10.1427 -5954 4 41.1368 9.75783 38.3095 7.23604 3.04516 -5.74389 -5955 6 53.3619 29.0937 24.5785 -40.2757 11.297 7.14485 -5956 4 52.5565 28.5537 24.7901 26.871 10.2044 -0.818821 -5957 4 52.9453 29.9599 24.3491 20.4755 -15.9472 -3.03 -5958 6 54.9044 15.544 40.7081 25.545 -57.3548 17.1629 -5959 4 54.9892 16.405 40.3633 -12.4948 43.2864 -12.4113 -5960 4 54.018 15.2891 40.9908 -7.57666 14.2468 -5.0348 -5961 6 46.3994 17.0672 31.8767 -6.245 16.1286 -17.5712 -5962 4 46.5114 17.9797 31.5283 3.34232 -11.2714 9.55259 -5963 4 45.8128 16.6602 31.1996 2.74349 5.02824 21.6551 -5964 6 36.898 25.0477 23.0493 11.3229 21.4084 -39.4528 -5965 4 37.2029 24.9737 23.9235 7.13326 -1.42781 43.2733 -5966 4 36.3025 24.3424 22.8486 -15.8402 -9.5757 6.36085 -5967 6 11.3692 4.41343 15.9249 15.7896 22.4119 -17.7964 -5968 4 11.3725 3.62473 15.3598 -3.28732 1.6252 14.2587 -5969 4 11.7055 5.11941 15.3214 -6.01385 -9.48847 12.8461 -5970 6 12.7845 7.07125 19.464 -10.6801 6.56169 22.7508 -5971 4 12.8604 6.27981 18.9655 14.1597 -21.8558 -24.6024 -5972 4 12.2771 6.71627 20.2197 6.8185 19.6013 -8.61559 -5973 6 12.0681 33.6471 17.5522 -1.52085 -17.496 -42.1785 -5974 4 11.9445 34.1189 18.3508 -6.25092 12.897 34.2466 -5975 4 12.5251 32.8183 17.7704 2.9394 6.95993 4.68875 -5976 6 10.2419 4.74292 2.55933 22.7613 10.361 1.71337 -5977 4 9.42389 4.50476 2.9876 -9.73314 -9.75152 7.74431 -5978 4 10.9687 4.12007 2.82053 -14.8261 2.90481 -11.2179 -5979 6 4.58785 36.8771 12.1606 -7.79451 -50.5455 -28.0593 -5980 4 4.4315 37.6675 12.6216 -0.588552 45.9766 17.7929 -5981 4 5.40236 36.9214 11.6472 0.781205 5.58305 7.99313 -5982 6 30.7591 35.3322 25.8391 -38.6972 -6.70904 -25.8809 -5983 4 31.308 35.3014 26.6139 2.09136 -3.6723 11.5509 -5984 4 29.8922 34.8696 26.0006 25.0535 4.09477 3.57125 -5985 6 20.1826 7.15897 1.87495 42.3449 13.1453 -15.8992 -5986 4 20.9155 6.54161 2.14653 -26.0098 16.5163 -6.36728 -5987 4 20.7109 7.92751 1.4772 -24.8109 -25.5601 12.7141 -5988 6 21.7554 6.89613 28.9929 -8.55274 -2.37394 -9.1913 -5989 4 22.0764 7.2366 29.8207 3.60587 3.07422 19.5812 -5990 4 22.5251 6.52709 28.5653 7.82832 -0.878326 -6.51175 -5991 6 6.87782 37.1389 6.94163 -1.13334 10.8563 13.3375 -5992 4 7.36847 37.9928 6.7949 -15.2779 -15.8129 7.53623 -5993 4 6.56156 37.0941 7.87645 12.8328 8.43507 -22.3513 -5994 6 37.1951 18.3599 16.3051 31.8484 54.3956 -63.0636 -5995 4 36.5686 18.6502 16.9278 -28.3708 4.63663 38.6073 -5996 4 37.3394 19.2548 15.8115 -3.93301 -42.965 18.1753 -5997 6 52.3874 25.498 31.3134 14.111 8.09505 3.74503 -5998 4 52.2596 26.4307 31.6656 16.8187 -33.1452 -9.3176 -5999 4 53.3531 25.244 31.2999 -24.6813 13.8962 6.4969 -6000 6 3.93514 39.8328 16.38 27.5969 -10.0907 -6.6773 -6001 4 3.11618 39.8354 16.8714 -5.56329 -11.6849 3.14974 -6002 4 4.25813 38.8985 16.2148 -16.7217 35.1377 3.93655 -6003 6 26.055 14.6352 18.3097 2.48745 23.0231 -5.4837 -6004 4 27.0121 14.5315 18.422 -4.58232 5.3017 0.111087 -6005 4 25.8831 15.6122 18.2324 0.591934 -25.1482 1.36918 -6006 6 22.1861 39.625 23.6336 -13.0035 -7.16992 22.0669 -6007 4 22.5756 40.4198 23.3178 20.0241 20.7615 -16.9022 -6008 4 21.775 39.9577 24.4575 2.36146 -17.5943 -7.81238 -6009 6 5.9827 12.8747 22.3739 5.28791 3.19174 -0.347139 -6010 4 6.16079 13.1981 21.4813 -0.557605 -0.80783 -0.954564 -6011 4 6.85402 12.6686 22.7296 5.64669 -4.60509 -1.11135 -6012 6 48.9358 28.1656 34.7093 -34.12 -15.1013 -7.57113 -6013 4 48.3009 27.4712 34.4428 -1.24475 21.7165 7.07681 -6014 4 49.7483 27.6911 34.6564 33.1581 1.27133 3.59264 -6015 6 7.76665 22.4378 33.2356 5.82113 4.36953 2.134 -6016 4 7.99414 22.0593 34.0982 -2.05459 -3.4103 -7.93698 -6017 4 7.15982 21.8587 32.7652 -2.05153 -2.03416 7.79212 -6018 6 41.0903 39.5994 11.7192 28.8485 25.6095 5.96672 -6019 4 40.6961 40.3697 11.3388 -29.9964 5.48828 -17.7316 -6020 4 41.854 40.0697 12.1081 -2.33823 -21.5528 5.66509 -6021 6 26.8801 37.922 39.3457 -9.67122 -13.15 30.7983 -6022 4 27.1418 37.9976 40.2903 -3.7646 7.48977 -14.0985 -6023 4 25.9915 37.5069 39.4007 11.6973 7.1772 -10.1587 -6024 6 16.8317 41.5399 16.7862 15.0313 6.40425 17.7164 -6025 4 17.5506 0.178386 16.4567 -5.24562 -1.69226 -13.3924 -6026 4 17.0965 41.4441 17.7156 -14.9292 -9.12078 -7.2801 -6027 6 19.02 8.9948 17.6728 1.01249 -20.0254 27.6053 -6028 4 18.8256 9.92734 17.8397 -2.50665 -0.780218 3.94781 -6029 4 19.0722 8.45531 18.5284 1.63313 22.2167 -34.6872 -6030 6 31.0993 24.379 20.1031 -5.45136 7.30173 -0.0135243 -6031 4 30.58 24.6604 20.88 7.69136 -4.59203 -13.2888 -6032 4 31.7465 25.0718 19.9526 0.652083 2.88804 -0.364555 -6033 6 24.6121 6.3117 27.596 -14.2942 3.47042 8.51555 -6034 4 24.6855 6.72112 26.7154 0.000835906 -11.6728 3.52597 -6035 4 24.4562 5.35726 27.5796 2.29956 0.742888 -9.80031 -6036 6 11.6309 5.33579 8.21245 48.3472 17.5789 -13.0214 -6037 4 10.7447 5.097 8.35577 -43.9811 -8.24091 9.59422 -6038 4 11.6324 6.14291 7.66014 -5.62825 -15.0071 6.92232 -6039 6 16.4828 34.2339 17.2467 58.9453 43.3211 -11.1422 -6040 4 15.833 34.737 16.7643 -22.9367 -4.06405 -2.05249 -6041 4 17.323 34.8225 17.0684 -41.083 -49.3458 15.3182 -6042 6 40.7431 40.4645 8.52128 12.2314 -11.8005 -21.5431 -6043 4 40.0246 40.6751 9.09883 -14.9736 5.2464 12.3608 -6044 4 40.4244 39.6664 8.05294 5.87539 10.603 6.78918 -6045 6 42.7463 5.87875 14.2877 12.74 -3.29305 -3.26541 -6046 4 42.0588 5.87807 14.9272 -15.1719 8.11415 20.4154 -6047 4 42.5132 5.11812 13.7588 -0.0411089 -3.23222 -11.0769 -6048 6 14.3659 21.065 6.06718 -46.5802 14.1632 25.7131 -6049 4 14.5381 21.6726 6.80844 -4.55135 -9.99097 -5.53618 -6050 4 15.2049 20.8313 5.76105 45.2018 -10.2131 -22.6687 -6051 6 16.2987 37.772 18.1217 -43.41 26.7654 24.2454 -6052 4 15.4242 38.2299 18.3727 36.2216 -25.3097 -28.3843 -6053 4 16.6845 37.7048 19.001 13.5629 -5.49997 -6.41318 -6054 6 40.7915 27.7152 27.1158 9.45156 2.81801 -4.91689 -6055 4 41.5456 27.319 27.566 -3.53201 -5.16081 10.0516 -6056 4 41.2155 28.2976 26.4751 -4.07016 3.79859 -1.40954 -6057 6 44.9595 25.9846 14.0499 3.3218 -15.4841 -8.79479 -6058 4 45.329 25.1566 13.6433 -5.22711 26.2877 13.1546 -6059 4 45.4837 26.7406 13.7529 4.37393 -9.76715 -6.45081 -6060 6 2.62066 33.9505 21.2427 -16.9582 -3.86849 -3.69815 -6061 4 2.06211 34.7496 21.3041 9.37305 -3.74186 4.79914 -6062 4 2.1388 33.3568 20.6382 5.47892 10.3925 4.65279 -6063 6 5.77806 4.43691 12.8378 4.70319 28.9306 -8.8144 -6064 4 5.36233 3.72198 13.3221 -5.81749 -8.58488 4.20714 -6065 4 5.80863 5.24637 13.3804 -1.3041 -13.5761 2.8333 -6066 6 16.8665 5.92021 7.40582 23.56 -3.08178 3.03829 -6067 4 16.4354 5.08697 7.20958 -2.89912 -12.7512 -7.28137 -6068 4 16.1638 6.54304 7.4701 -21.737 13.5702 4.65232 -6069 6 17.8259 38.4084 36.8446 -8.45971 28.6621 19.1884 -6070 4 17.7005 39.3712 37.0468 11.155 -18.7052 -15.1769 -6071 4 18.5325 38.3077 36.2071 4.43545 2.51623 -4.89916 -6072 6 43.3084 20.5973 5.4325 -39.7754 20.35 -2.23031 -6073 4 43.0204 21.5105 5.15286 19.9417 -23.843 3.70329 -6074 4 42.4274 20.1471 5.43024 22.0601 -2.53082 1.71294 -6075 6 21.5318 23.3 30.4444 10.3709 20.0389 -42.3415 -6076 4 21.0369 22.9394 31.1576 -20.9289 -4.03021 22.2109 -6077 4 20.911 23.6578 29.7428 10.7798 -15.246 22.7192 -6078 6 0.249866 28.0345 36.1724 -10.1983 37.6035 -27.6546 -6079 4 1.05324 27.7572 36.576 20.3102 -14.8665 16.9966 -6080 4 0.540234 28.832 35.6712 -10.982 -12.5736 6.41543 -6081 6 3.04754 17.0516 11.5683 -6.97145 7.64509 -15.3824 -6082 4 3.16434 17.3061 12.4746 3.36597 -0.550097 20.9912 -6083 4 2.52404 17.7798 11.2137 2.91457 -3.72579 -4.7217 -6084 6 24.1788 37.0366 23.9551 -12.9856 4.64226 12.2764 -6085 4 23.6099 37.826 23.831 6.85326 -8.75197 5.00341 -6086 4 24.4012 36.9865 24.9175 -1.53567 3.17074 -21.6248 -6087 6 3.95494 20.5134 27.4915 2.8093 53.7214 17.1103 -6088 4 3.58105 20.0931 26.7551 -14.7022 -26.8908 -38.8522 -6089 4 3.8118 21.4686 27.2477 5.25372 -20.6261 11.8203 -6090 6 54.8404 2.77723 29.6182 19.2518 19.5174 31.7291 -6091 4 54.8688 2.43537 30.559 -2.71579 12.5717 -24.6672 -6092 4 0.596183 3.44189 29.5911 -17.1059 -25.2514 0.407437 -6093 6 27.1931 8.41834 31.7378 -5.45838 77.4793 -29.1542 -6094 4 26.7872 8.25949 30.8671 -2.01983 -12.8877 1.93898 -6095 4 27.4107 9.43311 31.6496 -7.24897 -56.0438 21.5563 -6096 6 30.967 1.65521 30.3853 -24.4372 0.252197 19.6085 -6097 4 30.699 0.824835 30.0215 -2.04196 -23.8902 -26.6583 -6098 4 30.1085 1.94064 30.7387 6.28416 6.26069 6.0985 -6099 6 26.4053 36.4472 36.8445 23.7132 4.61357 6.55265 -6100 4 26.2095 35.8808 36.1068 -5.45287 -5.64468 -12.8873 -6101 4 27.3732 36.593 36.8324 -14.4493 2.44748 -3.93886 -6102 6 51.2993 10.0458 21.7014 24.6671 -30.2423 2.93053 -6103 4 50.7417 9.318 22.0589 9.26734 22.884 -6.07289 -6104 4 52.1551 9.59094 21.4448 -31.6711 18.7199 5.84467 -6105 6 52.4308 12.3792 23.2584 -6.42579 27.1004 22.8118 -6106 4 51.6946 13.0394 23.3088 16.6887 -7.91574 -6.77392 -6107 4 52.0327 11.5757 22.9611 -11.4365 -20.1199 -14.9439 -6108 6 9.99751 38.3699 20.6117 28.0449 -1.18219 -11.795 -6109 4 9.42862 38.2366 21.3654 -6.81781 0.619005 12.6857 -6110 4 10.9196 38.1916 20.8926 -11.789 -1.89114 -3.31064 -6111 6 22.7111 33.2651 0.632604 -8.26324 25.0772 17.5737 -6112 4 23.6702 33.3984 0.628432 0.752102 -10.2993 -4.51528 -6113 4 22.4939 32.4115 0.275412 2.14165 -18.6843 -11.1325 -6114 6 14.0859 40.8716 25.4956 -8.46488 1.55142 -11.4693 -6115 4 14.0599 40.7138 26.4427 12.1567 0.227551 5.06398 -6116 4 13.2623 40.45 25.1949 6.8133 8.32038 -2.55804 -6117 6 42.7734 15.0947 14.9538 14.4784 5.50426 -3.8277 -6118 4 43.0583 15.7694 14.2817 -8.42225 -24.0175 22.033 -6119 4 41.8405 15.2241 15.1238 -9.70916 3.613 0.791575 -6120 6 30.2327 7.231 8.54228 -3.22532 10.2874 -46.9304 -6121 4 30.2058 8.2102 8.45082 -0.363858 -13.9116 11.7844 -6122 4 30.4404 6.92219 9.39771 6.32383 2.81905 38.5597 -6123 6 3.37293 19.847 41.3038 28.0406 -0.792001 0.268463 -6124 4 3.19157 19.2836 40.5407 -0.0866071 4.98821 -2.30354 -6125 4 4.34764 20.0104 41.227 -24.6382 -4.50526 4.46777 -6126 6 8.87233 25.1482 17.2024 12.9182 -25.3276 -29.7935 -6127 4 8.99656 24.7585 16.2934 -10.9438 23.5455 20.5923 -6128 4 9.70028 24.8859 17.6216 -4.47076 0.166054 9.91948 -6129 6 9.34357 14.9539 22.0324 -26.1912 3.45279 3.87325 -6130 4 9.00509 14.8035 22.9321 4.97494 4.93375 -7.4516 -6131 4 10.1685 14.4775 21.9786 8.71262 0.391972 2.49596 -6132 6 2.03472 4.77693 20.8549 -5.0231 -16.4156 -4.2241 -6133 4 2.70086 5.4497 20.9192 18.9425 7.91266 2.94425 -6134 4 1.28907 5.15394 21.3146 -15.2358 3.90158 4.43282 -6135 6 18.286 7.04631 3.85489 -3.97091 0.415968 51.7005 -6136 4 18.7541 7.10917 3.04736 31.918 9.65669 -29.8899 -6137 4 18.8529 6.48913 4.44789 -12.6499 14.6692 -9.5202 -6138 6 17.0004 19.1661 19.8445 11.8294 -6.56912 -12.2376 -6139 4 17.7808 18.891 19.3473 0.445698 5.6808 3.33406 -6140 4 16.3387 18.5282 19.5337 -1.78106 12.0244 12.6463 -6141 6 4.30992 6.55322 21.357 27.1319 -4.11604 -15.0588 -6142 4 4.37542 6.91771 20.4543 -7.8574 5.76294 11.3657 -6143 4 5.24976 6.29093 21.5457 -28.1422 4.34799 0.417434 -6144 6 20.7778 36.9247 35.6618 12.7574 4.02765 2.49936 -6145 4 20.2864 37.0887 34.8562 -7.2468 0.0429553 -2.15645 -6146 4 20.2346 36.372 36.2389 -2.87094 1.27188 3.61263 -6147 6 4.73067 15.0203 31.2359 -10.2649 -12.7571 22.9725 -6148 4 4.37694 14.8342 32.1428 11.1861 -2.73027 -21.4712 -6149 4 4.72677 15.9733 31.1768 1.84417 11.2425 -7.2724 -6150 6 2.35535 1.23403 17.5726 17.2813 12.9738 -21.7174 -6151 4 3.03402 1.36527 16.8495 -17.2186 -13.1695 22.3246 -6152 4 1.92973 2.10387 17.6452 0.590267 -7.80147 9.6411 -6153 6 34.6252 31.5686 19.7984 -1.60729 -4.66139 0.568696 -6154 4 34.8929 31.9422 18.9439 4.49305 -5.18782 4.12596 -6155 4 34.4714 32.3271 20.3758 -2.9002 2.23803 -3.07041 -6156 6 24.1913 21.6089 13.5036 44.4004 0.328862 15.9674 -6157 4 25.0757 21.8297 13.9142 -30.8821 -6.11275 -18.7564 -6158 4 23.5519 22.0563 14.035 -11.4749 15.2668 7.23318 -6159 6 37.218 41.0972 5.69166 19.5034 -37.5651 -15.7416 -6160 4 37.88 41.7374 5.923 7.59407 13.6828 5.23653 -6161 4 36.3807 41.3769 5.99879 -24.6171 21.3167 5.70938 -6162 6 8.42841 7.99247 20.2345 27.9918 -33.0924 -23.0682 -6163 4 9.34968 8.06233 20.5347 -4.8675 5.92304 8.61954 -6164 4 7.93058 8.66586 20.633 -20.9635 39.4709 23.1164 -6165 6 14.934 18.8758 36.75 17.7625 18.3313 11.0559 -6166 4 14.0949 19.1945 36.41 0.856939 4.31409 -3.77921 -6167 4 15.6034 19.6084 36.7133 -18.5855 -12.9909 -4.44137 -6168 6 43.9791 40.6449 18.6524 7.41508 -0.428335 24.9958 -6169 4 43.9624 40.7544 17.7052 -3.16787 6.2189 -16.8328 -6170 4 44.8981 40.8188 18.9384 -9.62798 -9.77666 -5.30663 -6171 6 33.7986 32.259 37.3472 -15.5926 9.65631 -28.1821 -6172 4 34.0274 32.2295 36.4014 -5.19534 3.83485 15.8105 -6173 4 34.1945 31.4931 37.7276 18.2887 -12.3889 13.4194 -6174 6 5.09973 29.2834 24.0252 13.8314 -2.01249 29.2407 -6175 4 5.66693 29.5091 24.8044 -5.06459 -6.54793 -18.8628 -6176 4 4.76417 30.1245 23.7257 -5.49348 12.2693 -6.11875 -6177 6 33.6015 36.4179 10.971 30.294 2.53226 6.78363 -6178 4 32.7735 36.2836 10.5343 -15.5054 6.45725 -2.01925 -6179 4 33.4383 36.5424 11.9099 -7.56878 -2.98124 3.33663 -6180 6 28.3001 33.6166 13.1114 -3.16981 -41.1231 7.22112 -6181 4 27.986 33.7275 12.219 -4.10441 9.98298 -8.29397 -6182 4 28.0891 32.6746 13.2632 10.0083 14.4728 2.55385 -6183 6 6.1623 19.0624 24.2873 5.31394 -11.2621 -36.8053 -6184 4 5.95503 19.8074 24.8143 -4.51254 28.8134 22.7686 -6185 4 6.28788 18.3114 24.8476 4.1007 -18.6743 20.2695 -6186 6 28.4211 19.9362 1.86305 -4.43245 7.71948 8.08869 -6187 4 28.5604 19.4518 1.05094 6.94613 -11.0067 -8.65768 -6188 4 29.2593 20.0693 2.30859 5.46778 1.78077 -4.74455 -6189 6 42.0505 23.9714 9.55892 6.22877 26.0941 -5.00732 -6190 4 42.391 23.8165 10.4395 -2.03908 -8.00084 11.8727 -6191 4 41.7886 23.1541 9.15249 -7.7641 -22.6922 2.79783 -6192 6 43.5253 7.315 27.4414 4.48568 -18.9578 -0.168547 -6193 4 42.7359 7.07504 27.9388 -6.2009 1.74131 6.88183 -6194 4 43.2052 7.88335 26.7439 -2.31843 16.2411 -9.46916 -6195 6 20.4956 32.9945 9.25625 -63.2008 -2.41398 62.3431 -6196 4 19.7614 32.7323 9.96384 46.0698 -1.29529 -42.5223 -6197 4 20.3338 33.9485 9.24422 8.88758 3.29294 -12.4302 -6198 6 38.0318 35.2729 15.9427 -5.10059 -23.3836 -5.94715 -6199 4 37.3995 34.9842 15.2568 2.89047 3.01243 8.00796 -6200 4 37.9835 34.6007 16.6396 -2.13864 4.37071 -5.14357 -6201 6 47.5248 20.8808 3.95546 13.1177 31.1209 27.8573 -6202 4 48.0834 21.3954 3.36869 -6.69878 -8.89675 -13.1919 -6203 4 47.6052 21.4353 4.7772 -13.2785 -23.1226 -13.8569 -6204 6 10.9875 31.6892 41.4239 15.5099 5.40423 7.74084 -6205 4 11.658 31.8708 40.7529 -4.12469 -5.30401 -0.84079 -6206 4 10.1343 31.6927 40.9879 -7.96504 0.77506 -5.12071 -6207 6 43.245 12.6563 2.56138 15.9633 -17.8577 -2.60545 -6208 4 42.9226 12.9752 3.38765 -12.1061 12.2594 19.7928 -6209 4 43.9805 12.0851 2.8659 -6.2276 8.95994 -12.8364 -6210 6 49.4104 25.4124 21.1593 7.68799 -7.2912 5.83542 -6211 4 50.1422 25.2884 20.5387 -8.96396 0.548785 -4.3756 -6212 4 48.9554 24.5515 21.2297 -0.219253 8.20777 -2.75058 -6213 6 1.96484 34.1377 26.4635 6.42117 -7.58108 12.8955 -6214 4 2.78995 33.6488 26.6876 -20.6965 7.00883 -11.752 -6215 4 1.22498 33.5087 26.4121 8.61724 -1.18295 0.134997 -6216 6 17.1337 20.8362 36.6743 -37.6695 15.6036 21.8376 -6217 4 16.9634 21.7284 37.0778 2.65776 -21.0237 -14.9647 -6218 4 18.0617 20.7108 36.604 32.6572 -5.60583 -3.13187 -6219 6 36.5992 10.9735 3.70439 10.6975 8.82737 -5.2901 -6220 4 35.7369 11.4094 3.76988 -2.71865 -0.136466 14.5734 -6221 4 36.9547 10.7712 4.57736 -11.0261 -1.49358 9.11508 -6222 6 14.2213 20.6732 21.973 14.9521 39.3927 -42.8738 -6223 4 13.9206 20.2439 21.1689 -11.1282 -8.72354 1.45028 -6224 4 14.6851 21.4628 21.5779 -7.13343 -24.0966 22.8635 -6225 6 33.9052 12.2539 9.56536 64.6676 -19.1083 -72.943 -6226 4 34.3898 11.482 9.88615 -11.1791 5.59008 13.1859 -6227 4 33.2619 12.5422 10.1406 -48.1209 12.4396 55.8498 -6228 6 21.8075 41.4938 2.15247 -4.53434 0.170379 -15.7872 -6229 4 22.04 41.6038 1.2069 -3.47083 0.972349 16.0219 -6230 4 22.4007 40.8419 2.51679 12.4955 -1.6466 3.58022 -6231 6 20.9241 10.4413 14.2084 23.7182 11.537 17.3335 -6232 4 21.6155 10.8692 14.7979 -25.0251 -17.572 -17.464 -6233 4 20.772 9.54041 14.5736 6.4121 16.6732 -7.22543 -6234 6 6.25992 4.45494 24.6446 -20.993 10.5392 9.58783 -6235 4 6.70633 4.20365 23.8452 17.869 -10.7134 -15.0213 -6236 4 5.71116 3.71075 24.9084 -2.77077 -5.20552 -8.90983 -6237 6 50.776 14.5967 23.4784 31.7068 8.96229 10.5861 -6238 4 51.3012 15.0259 24.1918 -10.5702 -1.89466 -14.6802 -6239 4 49.902 14.4731 23.8252 -15.4415 -8.6063 7.51113 -6240 6 52.7906 13.9066 9.67243 -4.11462 48.2741 -4.64476 -6241 4 52.8606 13.0389 9.99278 3.823 -46.6932 12.5875 -6242 4 51.8698 14.0585 9.47707 -15.983 -0.946523 -10.048 -6243 6 9.04475 2.0467 29.9184 -38.5307 -30.621 -19.1189 -6244 4 9.46565 2.82007 30.2002 17.3321 39.2201 17.0183 -6245 4 8.08016 2.26538 29.8177 25.0495 -3.86709 2.38687 -6246 6 7.14389 29.9898 26.2407 4.70582 -42.771 12.4286 -6247 4 6.53112 30.404 26.8495 -5.08686 4.52864 3.1398 -6248 4 7.41427 29.1442 26.7142 -2.42767 26.6911 -17.7681 -6249 6 49.1638 41.7413 14.3375 -4.64089 27.4779 2.19815 -6250 4 49.5241 41.3828 13.5134 1.94418 -6.50091 1.47491 -6251 4 49.3811 0.802946 14.3236 2.14399 -30.2019 -5.07663 -6252 6 5.64888 3.82667 19.1906 -2.72189 -11.1411 26.1263 -6253 4 5.18678 3.36179 19.9258 5.23606 10.5823 -14.7259 -6254 4 5.05621 3.82399 18.4509 -7.60985 1.79477 -11.7277 -6255 6 9.32681 35.8274 24.8975 3.55565 13.5922 8.51546 -6256 4 10.2018 35.8152 24.4762 -3.06017 -4.39849 2.56743 -6257 4 9.46171 36.417 25.6586 -3.66837 1.49938 -3.23358 -6258 6 53.0285 29.7558 11.5499 -7.83487 -2.48558 9.64451 -6259 4 53.3653 30.4407 10.9686 7.5475 4.44921 -4.95089 -6260 4 52.7971 30.2083 12.3783 3.5824 -3.07517 -4.75195 -6261 6 22.6104 9.96627 5.67467 11.8622 1.90434 48.3765 -6262 4 23.3836 10.3266 6.15809 -8.36646 -10.9093 -7.81297 -6263 4 22.6398 10.3769 4.83333 -6.21393 7.91547 -32.804 -6264 6 39.5293 19.6134 2.67969 28.3515 9.20962 14.5311 -6265 4 38.5781 19.5068 2.58618 5.24604 -11.8744 -9.9137 -6266 4 40.0367 19.3939 1.87869 -17.6459 -1.04308 -3.70363 -6267 6 45.0742 35.5802 7.80399 12.9966 -1.00157 -13.6899 -6268 4 45.1073 36.2582 8.46111 4.45786 22.5875 10.9896 -6269 4 44.5296 34.9182 8.21469 -15.7495 -15.8794 0.100297 -6270 6 29.7829 14.2459 9.96531 -11.2509 -10.5838 -6.95263 -6271 4 30.0063 14.1556 9.0247 4.7074 -2.26926 1.20969 -6272 4 28.8478 13.9409 10.004 20.3358 11.6689 4.42407 -6273 6 29.2532 30.1489 21.8872 -22.7358 8.41186 19.7293 -6274 4 29.1261 30.8351 21.2312 3.02893 4.58934 -9.48892 -6275 4 30.0577 29.6729 21.7506 17.9631 -9.68935 -13.2514 -6276 6 11.1028 18.8149 6.56446 12.6172 11.1172 -5.75863 -6277 4 11.2898 19.7306 6.3073 -12.9819 2.38317 -1.53669 -6278 4 11.9922 18.4416 6.57196 0.724871 -8.7617 2.86424 -6279 6 13.403 39.1446 13.4748 19.5871 -11.9429 -30.0571 -6280 4 13.7697 39.8507 13.9939 7.8117 10.5151 13.4831 -6281 4 12.6292 38.8582 13.9386 -20.2152 -7.12839 8.32373 -6282 6 50.1432 12.9893 0.138872 33.4511 24.3017 64.4039 -6283 4 49.8497 12.6921 41.2405 -20.6967 -26.8999 -59.7452 -6284 4 50.7523 12.3231 0.503203 -9.52656 2.062 -3.94446 -6285 6 47.8312 31.3446 27.7846 -28.8076 12.8422 -13.2841 -6286 4 47.8833 31.94 28.5222 10.4006 4.03183 17.8143 -6287 4 46.9755 31.6479 27.4044 17.0933 -18.1054 -4.43643 -6288 6 27.7087 1.63781 7.50008 21.5285 -7.57238 -25.6841 -6289 4 26.9556 1.59549 8.05597 -25.0455 5.22958 17.9803 -6290 4 27.5166 0.963037 6.82134 -2.90509 7.89899 -0.0646572 -6291 6 54.8922 20.8 16.0331 4.1789 -41.4982 -7.93337 -6292 4 54.9282 20.9554 16.9716 0.186425 8.83729 15.9831 -6293 4 0.211633 19.8495 15.948 -9.91253 29.0383 -5.43741 -6294 6 37.4291 33.0056 34.4398 -14.0977 10.8622 -7.94924 -6295 4 37.2978 32.0826 34.6133 -1.58878 -21.6351 7.1631 -6296 4 36.5764 33.2755 34.0173 17.7258 4.45123 10.3439 -6297 6 19.5104 39.7742 6.7506 5.90241 -38.4201 -4.61078 -6298 4 19.1293 39.2182 6.01225 10.8403 19.9531 16.5545 -6299 4 19.9162 39.0938 7.35425 -12.9804 24.3225 -11.3083 -6300 6 32.4399 2.72699 8.06906 17.0773 23.4006 1.78158 -6301 4 32.9347 3.14941 8.81642 -19.9733 -16.2934 -9.37408 -6302 4 31.5531 2.49842 8.37658 0.516726 -6.41942 5.39598 -6303 6 12.9757 16.0915 4.06618 3.48233 -26.1302 -11.2272 -6304 4 12.5744 15.6527 4.83433 -0.695682 4.00385 -3.98901 -6305 4 13.3513 15.3473 3.55621 -4.30287 11.2057 5.6128 -6306 6 4.64677 29.9233 5.42983 -10.8182 14.2385 -56.8973 -6307 4 4.99957 30.1958 4.52107 -6.90737 -7.02982 36.161 -6308 4 3.86081 29.3683 5.18005 29.0195 11.7205 17.0104 -6309 6 29.7541 32.1122 24.0662 13.5325 13.0696 7.67536 -6310 4 30.657 32.2311 24.4313 -14.6232 -5.62961 -5.85099 -6311 4 29.8358 31.5529 23.3009 -2.99915 -14.1964 -7.88188 -6312 6 11.8689 30.6971 33.4711 -8.01032 -39.2081 28.7873 -6313 4 11.8961 29.8478 34.0479 -0.904256 41.1124 -29.4381 -6314 4 12.7288 30.7703 33.0546 6.62137 -3.78113 1.33903 -6315 6 17.3676 40.4123 27.3051 45.9752 30.8726 -27.1152 -6316 4 17.3095 41.3718 27.4557 -2.78012 -6.90788 -0.219066 -6317 4 16.6513 39.9873 27.6906 -54.0346 -15.2197 27.4879 -6318 6 8.66734 4.89901 8.93063 6.14116 -5.58058 -4.6479 -6319 4 8.35347 5.40804 8.18272 -1.2331 1.82325 -6.13974 -6320 4 8.16334 5.22925 9.67691 0.199365 1.34734 7.84993 -6321 6 39.5604 17.6833 9.57201 22.5105 -50.1639 -23.667 -6322 4 39.2658 17.6048 10.464 -10.5204 8.51393 23.2154 -6323 4 39.725 16.7168 9.31019 -10.6666 45.7312 -1.86495 -6324 6 31.4955 30.1755 28.5516 10.628 -19.507 17.1882 -6325 4 32.3525 30.3948 28.1778 -6.71462 8.32315 -8.11857 -6326 4 31.74 29.3729 29.0438 -14.9082 5.37925 -0.357203 -6327 6 52.6685 19.2672 40.0663 9.25056 16.4026 -20.0757 -6328 4 53.0106 18.7322 39.321 -9.61724 -4.6138 17.4516 -6329 4 53.0677 20.1385 39.8955 -5.74465 0.792691 -1.74468 -6330 6 3.24164 7.81666 9.85998 28.0429 9.66948 1.15728 -6331 4 3.83019 8.53432 10.2304 -23.9275 -17.8293 -12.7584 -6332 4 3.84853 7.29279 9.3074 -9.38214 5.4782 3.90821 -6333 6 23.129 35.218 35.5945 -25.4929 1.01472 15.9258 -6334 4 23.7784 35.3391 34.9359 33.2897 3.00284 -24.4901 -6335 4 22.5015 35.9398 35.4197 -4.85807 -5.03855 8.29984 -6336 6 19.51 14.0653 20.8221 -35.7596 -3.44758 -1.61502 -6337 4 19.8587 14.4985 21.6011 13.4146 6.44294 7.16022 -6338 4 18.5274 14.0852 20.9637 18.4505 -1.93413 -5.69736 -6339 6 23.6205 15.8624 24.0207 6.44012 -27.6666 -1.73497 -6340 4 23.7023 16.8084 24.0387 5.71305 22.1977 -2.17526 -6341 4 24.4604 15.4749 23.6823 -15.4387 15.2983 3.34328 -6342 6 0.280487 30.496 6.10097 2.10248 14.5258 38.6463 -6343 4 54.969 30.1752 5.28655 -5.78718 -18.1599 -43.8305 -6344 4 54.4568 30.8162 6.51538 2.11893 2.60892 6.09244 -6345 6 4.88818 13.213 29.1211 -10.1066 -44.834 -24.7823 -6346 4 4.81121 13.8494 29.7943 -5.77674 34.7781 35.8081 -6347 4 5.65875 13.4519 28.6173 14.302 5.76116 -10.624 -6348 6 54.2113 27.2762 19.1921 -15.5686 -30.3542 31.9917 -6349 4 0.068746 27.3681 19.6083 11.8738 0.793184 4.88761 -6350 4 54.2438 27.8077 18.4285 0.565084 22.1088 -37.313 -6351 6 13.9147 35.7477 9.19539 -9.45761 -42.0549 -30.4782 -6352 4 13.6498 35.0288 8.53341 12.0253 23.1831 27.3793 -6353 4 13.9217 36.5134 8.63033 3.91359 16.7787 -6.83247 -6354 6 5.91895 31.9062 18.8199 -10.5522 26.6577 -12.1166 -6355 4 5.59368 32.8276 18.7738 -3.70357 -9.82177 15.0022 -6356 4 6.3357 31.8271 17.9661 5.53766 -12.0386 -9.76018 -6357 6 5.80079 28.8629 9.48582 -4.23387 2.66619 -7.91216 -6358 4 5.1492 29.3316 10.0156 -4.194 3.81529 3.65919 -6359 4 5.26808 28.2356 8.96551 5.75879 5.11243 0.385299 -6360 6 40.1186 6.06288 9.7252 27.6823 -14.9678 -34.8134 -6361 4 40.0604 6.61837 8.91786 -4.97866 -6.72317 19.9534 -6362 4 40.8451 5.41953 9.46609 -26.5422 19.2978 14.9684 -6363 6 20.3249 13.4665 41.4109 48.5393 0.491453 -34.6424 -6364 4 21.248 13.7047 41.7262 -35.6043 -9.97545 -2.58991 -6365 4 20.4078 13.625 40.4256 -17.6073 -2.89865 23.6593 -6366 6 14.4355 21.7431 27.3521 26.8888 -5.93952 12.1752 -6367 4 15.3929 21.7238 27.5426 -15.4302 4.65814 3.66232 -6368 4 14.4086 21.5632 26.4128 -6.38145 3.02673 -3.91912 -6369 6 38.7552 1.80385 30.0529 11.0268 -28.3612 -27.359 -6370 4 38.4475 1.96331 30.9218 -11.1335 10.8767 32.3314 -6371 4 38.864 2.66369 29.6567 5.01485 14.1269 -3.82072 -6372 6 5.6038 10.8537 14.1812 -8.02182 -19.6512 10.0037 -6373 4 4.967 11.5707 14.1035 -3.71772 1.30399 -2.93081 -6374 4 5.11243 10.0991 14.6 11.6474 17.9462 -13.8385 -6375 6 45.4185 36.7135 27.9228 -18.8199 18.417 -42.2307 -6376 4 46.0687 36.7087 28.6222 8.21134 6.27257 3.16342 -6377 4 45.7172 37.2784 27.1471 -3.80026 -24.227 32.4306 -6378 6 54.0799 35.0377 20.3974 -0.144446 0.236923 -11.8112 -6379 4 53.8476 34.1116 20.536 0.519878 -4.41527 -2.37245 -6380 4 53.9532 35.2077 19.4441 0.866973 -0.817495 13.7238 -6381 6 42.0671 14.221 28.4749 -2.16655 -3.30611 3.54679 -6382 4 41.9442 13.9043 29.3971 9.00113 8.16851 -11.079 -6383 4 42.9986 14.4434 28.31 -2.56617 -4.72525 9.98454 -6384 6 34.845 7.68802 26.7053 1.50556 20.2543 7.34306 -6385 4 35.7046 7.39142 27.0344 -1.60005 -9.47728 3.59716 -6386 4 34.4934 7.05976 26.0702 4.4346 -10.8207 -3.70702 -6387 6 49.6605 30.7141 23.8514 -28.5275 -6.56067 -11.9374 -6388 4 50.4604 31.1934 23.8565 34.1351 17.5516 -0.640456 -6389 4 49.8146 29.9659 24.4072 5.37992 -19.8924 15.651 -6390 6 50.8948 7.80148 14.1671 21.5777 -12.9452 34.2787 -6391 4 50.8247 6.96775 13.7105 -4.99079 -12.0182 -18.7136 -6392 4 50.5655 8.51894 13.6572 -15.7049 17.9748 -24.3233 -6393 6 4.26893 39.4826 27.8512 8.9926 -8.51629 -1.47833 -6394 4 3.65831 40.2241 27.8513 -3.04259 7.34368 5.94949 -6395 4 4.00328 38.958 27.1013 -12.9816 -10.5728 -11.1653 -6396 6 8.75177 32.8341 8.22283 -21.5639 -30.1985 -34.1316 -6397 4 8.2383 32.1284 7.72694 10.6374 17.547 21.6449 -6398 4 8.83279 33.5372 7.56693 3.76401 9.53239 7.06969 -6399 6 52.9594 25.4882 9.38297 -25.0802 50.1357 20.0056 -6400 4 51.9882 25.4292 9.65119 35.7509 1.27265 -17.7678 -6401 4 53.158 26.4759 9.49827 -6.53976 -44.9947 -5.62964 -6402 6 29.5661 36.7256 19.4603 5.44621 -17.3757 32.4066 -6403 4 29.5786 37.3961 18.7906 9.88328 7.74732 -15.4263 -6404 4 30.4565 36.6309 19.8726 -14.3545 4.38723 -10.5986 -6405 6 52.3236 36.1013 25.1169 17.8415 -25.8683 -35.0149 -6406 4 52.9656 35.7372 25.71 20.0999 5.67458 7.00157 -6407 4 51.6595 36.4261 25.6714 -35.904 19.3861 23.0835 -6408 6 21.182 15.7103 31.1872 -18.8583 3.19523 -20.0756 -6409 4 20.6533 16.2005 30.5215 19.2403 -4.60119 13.454 -6410 4 20.518 15.2243 31.6931 2.46505 1.20146 2.10658 -6411 6 10.6569 22.4337 39.4531 2.51655 -26.4213 -37.4968 -6412 4 10.8327 22.4219 38.4645 -4.29248 9.16844 28.2769 -6413 4 10.2506 21.5589 39.6181 7.08653 12.2011 0.686531 -6414 6 25.1113 11.6729 22.7164 -12.9971 -0.576423 -18.0399 -6415 4 25.1382 11.4787 23.6279 21.2779 0.00518046 39.517 -6416 4 24.1824 11.5118 22.5586 2.84555 -0.272219 -17.8246 -6417 6 31.7896 10.4703 2.90217 -23.2712 -10.1944 -9.79051 -6418 4 32.6146 10.7499 3.28348 13.8778 6.97942 -8.99307 -6419 4 31.8394 10.4464 1.92418 10.0551 5.29594 18.2662 -6420 6 52.4849 36.4361 22.1663 -9.62786 -33.6069 5.21212 -6421 4 53.146 36.0606 21.5474 -12.5852 0.946736 4.3316 -6422 4 52.0694 35.6392 22.6209 17.7505 30.3514 -16.202 -6423 6 46.2093 40.0329 26.9877 0.0297183 29.9961 33.6049 -6424 4 46.4751 39.2742 26.5126 9.55695 -26.8643 -22.4205 -6425 4 45.9048 40.7092 26.3771 -3.76152 -2.91476 -3.34389 -6426 6 24.0885 36.7218 39.1011 7.12362 -3.16907 -4.80429 -6427 4 23.5999 35.9078 38.9667 11.8985 -11.6148 -5.9332 -6428 4 23.4559 37.2234 39.5891 -11.7402 16.6095 17.3029 -6429 6 22.3514 7.42547 31.8169 -35.2707 -41.8068 15.3628 -6430 4 22.2213 8.33277 32.0647 5.94025 21.3422 4.40196 -6431 4 21.6465 6.92073 32.3398 32.1745 21.6054 -24.7594 -6432 6 14.3502 18.3597 4.09728 -2.0055 -9.38358 23.348 -6433 4 14.1099 17.4219 3.93107 -0.92654 19.6042 10.3569 -6434 4 14.0726 18.5364 5.03654 13.0175 -10.3464 -23.9346 -6435 6 27.3175 38.46 0.124188 33.1007 -9.911 1.68747 -6436 4 26.9395 39.2806 0.463932 -4.88512 2.40457 5.81864 -6437 4 28.2608 38.413 0.45438 -35.2324 2.96259 -2.16122 -6438 6 18.6695 0.162292 12.2239 -43.166 1.81748 26.3235 -6439 4 17.7303 0.262878 12.5713 26.4571 2.30278 -22.2908 -6440 4 18.9433 41.3202 12.7499 8.63834 -11.46 6.42912 -6441 6 49.423 24.9792 25.3382 20.605 1.42964 -0.346179 -6442 4 48.5484 24.7002 25.6009 -12.613 -0.556076 -3.92373 -6443 4 49.3508 25.8032 24.8352 -9.8769 -5.62219 -3.2466 -6444 6 52.0685 20.2858 15.7446 -45.9435 -8.75518 14.7384 -6445 4 52.9731 20.5149 15.783 39.268 6.79994 2.42829 -6446 4 51.7449 20.2597 16.6676 4.81444 3.79951 -9.92674 -6447 6 49.6576 15.6472 38.4942 19.425 -17.6129 -0.00729052 -6448 4 49.2099 16.0165 37.7231 -6.98596 1.36616 -1.50856 -6449 4 49.5102 16.1958 39.2633 -14.7214 13.7889 5.58845 -6450 6 15.9211 23.7235 13.4193 23.3289 -36.8815 11.3263 -6451 4 16.506 23.7025 14.2147 -19.633 8.70021 -19.3267 -6452 4 15.5217 24.5725 13.2813 -7.62789 19.6624 11.7876 -6453 6 14.3566 29.1635 14.3074 -12.0826 22.9902 -11.8551 -6454 4 14.1263 29.6193 13.4563 6.10678 -19.1115 21.2229 -6455 4 14.1254 29.8374 14.9735 4.9154 -5.66101 -4.10969 -6456 6 30.4264 19.8612 16.8883 21.8822 -42.1222 -1.02119 -6457 4 30.7186 19.5182 17.7453 7.89699 4.38367 -1.56912 -6458 4 29.8579 20.5689 17.0557 -25.7709 36.069 4.20145 -6459 6 21.3137 21.0352 23.1207 17.1515 -0.95565 24.203 -6460 4 22.2175 21.149 23.495 -16.5785 2.35003 -9.75668 -6461 4 20.7278 21.0809 23.8918 1.9436 3.71589 -4.02445 -6462 6 32.3543 0.425745 25.2542 2.91189 -3.53517 -15.1456 -6463 4 32.2281 0.339162 24.2978 10.7775 -1.18886 4.59452 -6464 4 31.5305 0.792307 25.5362 -21.0885 6.89421 14.2132 -6465 6 26.144 32.4145 27.5224 1.5207 15.2147 0.716215 -6466 4 25.5792 33.1636 27.3089 1.00017 8.92672 2.49827 -6467 4 25.8737 31.7446 26.908 1.40169 -15.6227 -12.5261 -6468 6 31.6924 23.0038 41.4488 2.9891 4.25247 18.5975 -6469 4 32.5817 22.7219 41.7427 -10.6129 2.19465 -7.80737 -6470 4 31.0787 22.7203 0.234806 2.54762 2.31931 -6.22567 -6471 6 54.3675 17.8383 10.7129 6.79577 23.0573 52.4548 -6472 4 53.55 18.2477 10.4428 -14.1319 6.62767 -11.4304 -6473 4 54.6119 17.1874 10.0964 4.54612 -26.2874 -33.1105 -6474 6 15.4111 28.5567 8.624 -23.5209 17.7221 -14.2225 -6475 4 14.7074 29.0083 8.07604 23.4242 -18.2482 9.63627 -6476 4 15.9053 27.9212 8.07642 -10.4486 8.35345 -4.07335 -6477 6 21.923 22.3267 27.6697 4.39763 -15.072 3.90508 -6478 4 22.0757 23.261 27.7591 9.36727 14.8743 -6.39222 -6479 4 22.0153 22.013 28.5729 -4.02641 -8.91923 4.38679 -6480 6 2.936 17.0367 8.13301 26.8737 -0.816539 -9.93732 -6481 4 3.80704 17.1417 7.69888 -17.5309 -13.2134 -6.39661 -6482 4 2.90872 17.8246 8.6543 -8.08771 15.2208 15.3377 -6483 6 27.578 18.2783 3.98106 42.3665 -21.0645 -7.59535 -6484 4 26.9838 18.9866 3.87461 -35.9411 25.5305 -3.32845 -6485 4 28.3853 18.6252 3.56495 -11.0807 -10.9366 8.58166 -6486 6 24.7671 24.5333 8.4671 -3.55267 7.94183 -11.8318 -6487 4 25.0347 23.6359 8.24775 3.17664 -3.45343 1.13667 -6488 4 24.5725 24.5372 9.40731 3.34714 4.39373 0.466573 -6489 6 41.9868 30.4684 13.7801 28.6364 -21.7839 2.09937 -6490 4 42.9472 30.4515 13.6527 -5.43777 20.4489 -0.76134 -6491 4 41.8419 29.5153 13.705 -23.7897 6.87836 6.63004 -6492 6 15.6883 34.6775 41.5701 28.3539 0.757195 5.77675 -6493 4 16.4499 35.2822 41.5481 -1.40988 -1.74654 9.10263 -6494 4 14.9914 35.2483 41.869 -21.9895 7.57474 1.73196 -6495 6 11.1473 19.7636 40.5906 -7.01786 -3.24743 -12.0486 -6496 4 12.0915 19.8265 40.3679 -7.75233 -10.0339 3.8807 -6497 4 10.7912 18.9088 40.243 10.6872 10.1147 9.9033 -6498 6 47.4955 34.5311 14.2936 14.7321 -31.661 -1.66099 -6499 4 46.9342 35.3117 14.2317 -6.87541 2.2103 -19.2779 -6500 4 47.4978 33.9137 13.4978 -3.14061 27.4792 16.9676 -6501 6 12.3981 26.9866 28.4861 26.5251 -74.1409 -7.08463 -6502 4 13.226 26.8461 29.0045 -10.1246 11.0422 -0.548558 -6503 4 12.3843 26.0988 27.9797 -6.45597 45.1087 15.272 -6504 6 27.6352 16.207 39.8297 -11.2321 14.8168 6.13397 -6505 4 27.2166 15.4175 40.1567 -13.0977 -6.13948 14.8525 -6506 4 28.2209 15.8539 39.184 23.7477 -3.37658 -20.6816 -6507 6 33.4012 31.2187 27.2758 -9.34358 5.5086 -22.6345 -6508 4 34.125 31.7676 27.5967 0.31405 7.14405 -9.79506 -6509 4 32.8978 31.7031 26.5666 21.3968 -7.09575 17.214 -6510 6 39.0983 39.5786 31.9234 0.802497 -2.15341 -0.194752 -6511 4 38.8245 39.6381 30.9898 -0.836727 0.773065 10.2743 -6512 4 38.5517 40.2102 32.4207 8.13236 -5.11153 -2.10971 -6513 6 22.8875 16.5662 19.9556 -18.6429 -47.4181 0.677292 -6514 4 23.2714 15.7467 20.3471 4.73069 19.3315 1.98369 -6515 4 22.0725 16.1814 19.5628 10.6014 14.9969 -2.71875 -6516 6 23.9725 21.8734 10.5896 -27.2099 14.1239 -19.8382 -6517 4 22.9807 21.8764 10.5048 23.1264 -0.860286 11.7265 -6518 4 24.1883 21.166 11.1844 -1.51334 -13.3572 20.4185 -6519 6 40.1791 25.4384 2.79385 3.27033 10.4385 -27.7191 -6520 4 40.1215 24.9503 3.60378 -1.57927 -2.0951 21.761 -6521 4 39.8421 26.3422 2.89187 -4.34677 -6.39915 11.9951 -6522 6 15.0222 19.7637 9.4145 -47.1416 28.5942 15.5409 -6523 4 14.7277 20.7258 9.2944 13.9352 -33.0223 -5.4956 -6524 4 14.1981 19.3167 9.80349 37.3596 11.4933 -12.2096 -6525 6 7.16734 24.8761 0.122492 -38.9593 -14.3052 4.78001 -6526 4 7.92262 24.7355 41.4818 28.9246 2.82935 -8.29154 -6527 4 7.37325 25.3267 0.937782 12.1222 2.94845 5.10402 -6528 6 43.395 10.8961 31.3295 35.6095 27.14 14.9602 -6529 4 43.8689 11.0333 30.4778 -14.9331 -12.4968 13.4948 -6530 4 44.125 11.0026 32.0067 -24.5429 -5.74221 -22.764 -6531 6 13.8447 19.0699 27.8622 -3.35019 15.2359 -6.83255 -6532 4 12.9833 18.7163 28.0985 -4.55464 1.4506 5.93475 -6533 4 13.7874 20.0538 27.8435 3.60016 -14.5834 0.921784 -6534 6 3.48728 19.5892 9.61273 -55.7314 7.48447 -10.4955 -6535 4 2.69835 20.0905 9.96963 22.9021 -19.0673 -4.76373 -6536 4 4.2501 19.9102 10.0538 23.4289 5.03115 15.3445 -6537 6 51.0169 19.4212 7.7195 26.3048 39.1054 -53.7154 -6538 4 50.748 20.2575 7.21364 -2.7273 -32.3506 28.7892 -6539 4 51.8579 19.2204 7.21263 -29.2082 -7.0208 18.9647 -6540 6 42.2149 2.6091 10.4112 25.8935 -20.0624 -18.8025 -6541 4 43.1623 2.45904 10.6444 -24.152 11.2038 4.82319 -6542 4 42.1853 2.33112 9.4647 -3.80011 10.6068 21.7004 -6543 6 30.7928 6.43901 35.1986 -21.6247 -20.8821 1.11778 -6544 4 29.8295 6.39304 35.3716 10.0359 5.79706 -2.44011 -6545 4 31.0478 5.50645 35.0814 0.649811 9.90023 -1.69835 -6546 6 52.8722 36.96 18.5947 9.01539 9.27494 -7.55423 -6547 4 52.0657 36.4448 18.5061 -12.9065 3.13675 2.3407 -6548 4 52.6935 37.8522 18.2226 2.03776 -15.609 7.12003 -6549 6 44.2018 6.29599 1.04883 9.29405 17.1768 7.51252 -6550 4 44.5044 7.06671 1.58929 -4.49779 -17.4812 -0.431191 -6551 4 44.952 6.10526 0.487985 -0.115844 -2.61588 -3.46335 -6552 6 42.1326 38.6047 31.1849 18.5327 -13.3283 33.8135 -6553 4 41.7834 38.9864 30.4106 -14.9936 10.8543 -35.8121 -6554 4 41.4904 38.8324 31.8627 -0.641051 1.33351 1.93 -6555 6 43.7219 12.8013 9.05519 -6.282 7.91343 -40.7352 -6556 4 43.3171 13.69 8.87718 10.3632 -22.6116 8.3507 -6557 4 43.9578 12.415 8.15014 1.61383 14.3586 37.3488 -6558 6 13.4062 0.438838 6.51561 -30.6084 29.4042 -0.600484 -6559 4 12.9719 1.14899 7.05573 20.0807 -17.3818 -8.1595 -6560 4 13.3782 0.782754 5.59696 2.59294 -3.03922 8.63079 -6561 6 16.1217 13.2907 10.2805 -3.10591 -25.3511 -12.454 -6562 4 16.8946 12.7568 10.5076 8.02861 4.25978 2.86397 -6563 4 15.5299 12.6092 9.88546 -0.135156 17.9383 7.81515 -6564 6 1.59113 8.48217 4.69745 0.410151 -22.2633 16.3582 -6565 4 1.97054 9.1194 4.11301 8.92831 16.113 -22.7699 -6566 4 2.26765 8.43533 5.38895 -6.97239 3.0759 6.50405 -6567 6 37.2935 1.72102 10.5172 -13.7439 -9.21578 15.0824 -6568 4 37.1042 2.64553 10.595 10.0955 20.4226 -13.0857 -6569 4 36.8105 1.41855 11.2983 8.13599 -13.5394 -0.658926 -6570 6 53.8411 9.88961 17.6933 -45.7386 -38.9159 3.57486 -6571 4 54.5353 10.0399 17.0846 27.4782 6.59889 -23.5339 -6572 4 53.3721 9.08338 17.329 10.482 22.3983 14.0606 -6573 6 45.4787 30.6173 15.8038 -24.3966 -4.27047 13.1326 -6574 4 44.7717 31.1876 16.1963 22.3351 -9.42651 -10.1125 -6575 4 45.1907 29.6979 15.9324 6.84487 10.052 -2.21901 -6576 6 39.9241 16.6394 33.8426 -26.8877 -6.37158 -14.218 -6577 4 39.1549 17.2016 33.5476 23.291 -18.1751 3.42158 -6578 4 39.818 15.753 33.3934 2.94846 26.4583 15.0268 -6579 6 32.8532 24.7638 27.9368 9.55773 21.8346 -14.3088 -6580 4 33.6229 25.0593 28.4772 -14.6217 4.84572 -15.4057 -6581 4 32.6055 25.4822 27.2751 14.9958 -18.2832 35.5187 -6582 6 7.86628 31.6164 24.1091 22.2934 14.9204 62.1634 -6583 4 7.77595 30.8628 24.7489 -5.82572 16.0022 -25.8365 -6584 4 8.17309 32.3545 24.746 -24.9312 -26.1857 -42.8493 -6585 6 43.5324 41.3356 15.8165 16.5067 -5.02973 0.188395 -6586 4 43.1944 0.320073 15.7896 -5.69638 5.43212 -4.38793 -6587 4 44.429 41.3992 15.443 -10.6291 -2.88383 0.315207 -6588 6 20.021 29.5505 33.1902 25.0419 -7.98688 14.3875 -6589 4 20.8911 29.4069 33.5992 2.6372 -12.3274 -8.42754 -6590 4 19.6576 30.1636 33.8147 -14.9588 14.7065 -0.197692 -6591 6 43.4056 21.4569 18.6265 10.2156 -2.1017 15.5441 -6592 4 43.0498 21.3696 19.5313 -0.699705 -7.60676 -10.3888 -6593 4 42.9844 20.831 18.0298 -12.2248 -1.50447 0.773582 -6594 6 3.43117 19.1215 18.408 34.3393 4.70286 11.768 -6595 4 3.22621 20.0564 18.4267 -2.18643 4.81974 -5.59269 -6596 4 2.60088 18.6799 18.3703 -20.3233 -14.3491 -1.28903 -6597 6 41.6742 38.1112 16.3299 0.384784 -42.0766 -46.2559 -6598 4 41.8939 37.3404 15.6708 -9.75075 44.1094 34.3099 -6599 4 42.3403 38.1083 17.0131 5.25517 -2.87066 6.28124 -6600 6 7.56339 36.3915 10.5048 -18.8567 -13.4705 -13.5944 -6601 4 6.70677 36.1596 10.0967 9.18231 15.0261 0.193132 -6602 4 7.92251 35.493 10.5558 6.04756 10.3771 12.1048 -6603 6 36.2642 19.1103 34.8187 -40.4108 -29.7457 -43.4097 -6604 4 35.4719 19.3187 34.2477 20.3247 -4.92751 27.2967 -6605 4 36.4213 19.8813 35.3193 7.80254 33.8099 20.7293 -6606 6 53.576 24.9483 12.6399 1.20561 -0.517111 -17.326 -6607 4 53.6619 25.9414 12.669 8.79141 -29.2645 -7.24265 -6608 4 53.913 24.5623 11.7782 -4.09912 18.2899 28.1509 -6609 6 31.6824 10.4618 21.0892 -21.9557 -25.3726 -8.81809 -6610 4 31.4281 9.67391 21.5915 5.84781 10.5911 6.7189 -6611 4 30.8909 10.5838 20.5303 11.506 8.60894 0.332243 -6612 6 18.1093 28.7861 17.1823 13.2379 18.2354 -13.1758 -6613 4 19.074 28.7105 16.9739 -24.5165 5.38082 5.29014 -6614 4 17.7652 29.607 16.728 11.5472 -26.6353 13.0333 -6615 6 21.6834 18.2239 36.88 17.2587 0.811675 -5.67627 -6616 4 22.5671 18.027 36.4721 -27.7349 -1.55215 19.1593 -6617 4 21.6367 17.7543 37.7464 -1.70499 5.95625 -12.509 -6618 6 25.0551 19.0348 34.2287 -62.1041 -5.07763 23.2016 -6619 4 24.7663 18.3443 34.8719 5.43786 16.9757 -10.9409 -6620 4 25.8827 18.7578 33.9618 64.2031 -27.8273 -22.1538 -6621 6 15.5709 13.019 5.5539 0.00735057 -17.6807 20.5563 -6622 4 15.9927 13.3293 6.36292 0.0692085 12.4919 -5.39058 -6623 4 15.4491 12.0681 5.73828 -2.05735 13.2604 -17.7033 -6624 6 54.47 41.6402 14.7959 12.609 -13.6787 23.2741 -6625 4 54.8097 41.4531 15.6947 -1.45983 11.4249 -10.5768 -6626 4 53.7709 40.9948 14.7271 -15.6812 0.146288 -8.92901 -6627 6 1.6639 26.4809 31.3827 12.672 -25.15 69.1319 -6628 4 2.55491 26.3764 31.7735 -12.447 -0.333387 -5.00094 -6629 4 1.81595 26.6127 30.4938 10.6163 16.8649 -70.5286 -6630 6 32.3417 37.2868 29.6843 -28.8191 13.9029 5.49332 -6631 4 31.5776 37.8992 29.8843 22.0104 -18.6347 -4.04342 -6632 4 33.1171 37.6855 30.0945 4.79121 1.59444 1.77014 -6633 6 52.7104 21.0422 22.8867 -25.9211 15.4876 17.6965 -6634 4 51.8895 21.5407 22.5959 27.9099 -16.7396 2.24416 -6635 4 53.1785 20.6742 22.1421 1.33026 -7.16251 -14.9349 -6636 6 32.7465 28.5808 40.5193 19.5614 -2.95666 4.13778 -6637 4 32.1272 29.2507 40.2236 -19.1805 -2.02865 5.11045 -6638 4 32.5793 28.3106 41.4408 -7.78706 5.87783 -13.0149 -6639 6 23.6078 32.0654 16.3528 6.52471 10.7856 29.7964 -6640 4 24.3701 32.0729 16.9793 -11.8963 -10.2614 -20.8491 -6641 4 22.8856 32.382 16.9256 -1.99185 -7.37994 -15.8659 -6642 6 37.5296 9.17182 29.9714 -32.9897 5.30306 10.5453 -6643 4 36.7716 8.86544 30.5111 15.5785 -5.70066 -5.7121 -6644 4 37.1221 9.9689 29.5744 15.1662 -5.45151 -1.53858 -6645 6 2.26386 24.3835 14.5546 6.71022 -7.72281 -24.2479 -6646 4 1.85963 24.0133 15.3587 -6.19133 3.33276 -9.20692 -6647 4 2.05254 23.8227 13.7642 -0.610841 12.6744 29.5344 -6648 6 27.3686 28.7935 24.7702 8.50672 -13.2399 -34.495 -6649 4 27.2338 28.4442 25.6457 -6.20833 -8.14759 12.6395 -6650 4 27.3624 28.0447 24.1031 3.25167 21.2409 25.246 -6651 6 16.785 2.54959 14.3094 -6.20571 44.0359 18.8502 -6652 4 17.7332 2.53792 14.3228 12.8455 -14.2273 -3.64568 -6653 4 16.4133 1.8101 13.8617 -1.35631 -25.1723 -17.3636 -6654 6 21.8048 39.8028 36.8143 34.4281 41.1875 6.43987 -6655 4 22.7768 39.6281 36.9504 -24.2083 -5.20947 -5.56999 -6656 4 21.4132 39.0119 36.5213 -11.0202 -42.2818 -12.3994 -6657 6 14.0639 6.48367 41.5586 -1.33856 -25.5903 -39.7582 -6658 4 14.9412 6.10051 41.3922 2.86672 3.38346 15.7648 -6659 4 14.0719 7.05039 0.399753 4.3465 12.2327 22.8772 -6660 6 14.5548 16.5075 9.32956 22.0841 -14.7784 -21.2506 -6661 4 15.3586 16.5914 9.87503 -6.36199 2.72911 -6.08794 -6662 4 13.8899 17.0883 9.65711 -8.71884 14.1475 23.1102 -6663 6 8.67066 23.4815 30.5556 -44.0195 -7.59097 13.7496 -6664 4 9.49671 23.6557 30.1334 33.8338 1.75787 0.0184994 -6665 4 8.69311 23.4014 31.5307 16.0679 1.7618 -7.5699 -6666 6 37.6567 2.07706 19.9993 -10.7882 4.4912 14.9507 -6667 4 36.977 2.26584 19.3592 -1.31755 -8.36894 -24.369 -6668 4 37.311 2.65872 20.6865 17.7477 -2.01295 10.0374 -6669 6 42.7201 7.55732 8.02256 37.7013 -31.8103 68.6738 -6670 4 43.2078 7.90139 7.31041 13.9641 18.3531 -33.1003 -6671 4 43.4713 7.36984 8.74143 -54.3005 13.1784 -34.8973 -6672 6 38.5678 29.6657 6.85728 10.4727 -7.97498 12.0381 -6673 4 38.5138 29.2192 7.70857 5.95943 6.40388 2.63109 -6674 4 37.7242 29.471 6.47402 -15.8477 4.38345 -15.5494 -6675 6 42.5297 15.7017 39.7864 -1.2311 2.72873 2.24862 -6676 4 42.7877 16.6334 39.6476 -7.55712 -4.9727 -7.52807 -6677 4 42.0746 15.3358 38.9963 17.4435 12.5166 7.69263 -6678 6 19.8571 7.43592 22.0545 -24.1472 -5.51637 33.4113 -6679 4 19.2244 8.12179 21.7601 9.35088 -5.78158 -2.10146 -6680 4 19.4596 7.11536 22.9248 14.2781 17.6372 -34.9907 -6681 6 27.4149 3.22069 12.5516 40.9266 14.4549 -35.8463 -6682 4 28.3021 3.29229 12.0821 -30.0356 5.19144 18.8294 -6683 4 27.3767 2.28812 12.7581 -5.67627 -4.82192 6.74426 -6684 6 34.4116 6.50186 34.3661 -21.9879 -4.07114 7.78674 -6685 4 33.6675 7.13398 34.4265 8.52018 -4.33452 -1.60522 -6686 4 34.0848 5.70903 34.842 8.55338 12.1797 -0.556276 -6687 6 9.89342 27.9558 39.7643 36.6491 -8.46867 13.0669 -6688 4 10.8456 28.0225 40.104 -41.9626 -4.51635 -15.7261 -6689 4 9.67004 28.8098 39.3873 2.34979 10.3628 -2.65954 -6690 6 50.5619 22.115 6.39208 17.1303 26.4748 31.0688 -6691 4 51.4904 22.4109 6.45725 -8.74694 -11.3909 -7.00891 -6692 4 50.1939 22.6078 7.15954 -8.62199 -11.7106 -16.757 -6693 6 47.1151 11.4881 30.0373 19.0993 -20.4412 31.5796 -6694 4 47.2481 10.8506 30.7795 8.25865 21.4973 -13.9376 -6695 4 46.3269 11.1564 29.6474 -26.9131 -5.13028 -17.9745 -6696 6 25.9416 28.4741 9.79918 -11.6773 -32.55 32.2578 -6697 4 26.8348 28.2861 10.1548 -13.4597 2.20587 -7.83095 -6698 4 25.3328 27.8368 10.2912 20.3964 27.2145 -12.4741 -6699 6 35.4384 36.5941 19.4416 12.9267 19.1414 22.694 -6700 4 35.4164 36.6623 20.432 -0.885856 -8.21646 -20.3497 -6701 4 36.1159 37.2681 19.2232 -9.51806 -6.29836 -4.59986 -6702 6 39.0948 17.8654 12.2958 16.402 12.2899 -6.89152 -6703 4 39.0474 18.8007 12.5965 -2.38328 -10.6878 -1.40665 -6704 4 38.4419 17.3626 12.7715 -16.1853 0.319976 14.0097 -6705 6 2.67108 27.1436 2.40101 -1.75759 -3.65761 -8.1759 -6706 4 1.9876 27.5644 1.84788 8.2175 -2.76418 4.2561 -6707 4 2.53155 27.392 3.3289 1.87867 -1.67129 -3.85288 -6708 6 12.3359 32.2055 21.5153 -21.7508 0.12991 31.168 -6709 4 12.6488 32.0797 22.4173 29.0853 13.2861 -13.6486 -6710 4 11.491 31.8094 21.7155 -17.148 -0.720271 -25.2422 -6711 6 32.8833 32.3716 8.45599 -19.6455 -21.472 -14.5807 -6712 4 33.4538 32.8256 9.05859 9.48117 21.6574 11.6239 -6713 4 31.9723 32.7028 8.50155 9.17651 3.82723 3.41156 -6714 6 12.6485 6.44458 31.9777 -6.29944 1.49663 15.4125 -6715 4 13.1578 6.35833 31.1835 12.9638 -3.65534 -14.9347 -6716 4 11.7474 6.25334 31.7296 -4.07419 -1.29291 -2.47195 -6717 6 41.3645 27.7433 14.0415 -6.01814 -18.8263 -25.007 -6718 4 41.8124 27.3175 13.2596 -11.5333 15.588 22.1217 -6719 4 40.3975 27.5756 13.9407 20.5065 3.01622 5.4742 -6720 6 6.60161 16.499 25.4489 9.93734 -1.87947 -15.8553 -6721 4 7.35848 15.8951 25.4583 3.3895 5.33583 -1.00098 -6722 4 6.02379 16.0419 24.8253 -6.53341 1.34025 8.2366 -6723 6 21.7786 39.2974 13.3607 -58.7317 27.2846 42.4257 -6724 4 22.3848 39.3902 12.6828 41.4687 -6.70168 -50.5194 -6725 4 21.6228 40.2371 13.624 5.27297 -27.3266 2.34771 -6726 6 34.8408 6.01319 6.94562 -18.4641 -1.51643 5.78804 -6727 4 33.8445 5.90926 6.91888 31.3517 2.57767 -4.40922 -6728 4 35.1545 6.28252 6.0657 -8.54142 -2.93715 0.97402 -6729 6 33.0232 30.4151 33.1713 -30.7469 -3.39927 -39.9685 -6730 4 32.1382 30.6983 32.7963 25.7009 -18.3352 9.36685 -6731 4 33.1108 30.988 33.8978 7.7837 23.494 30.6115 -6732 6 15.4491 32.4129 12.2013 37.3068 -21.1945 16.3611 -6733 4 16.3823 32.073 12.2446 -28.3662 8.39135 1.47263 -6734 4 15.4224 32.8258 11.3561 0.313824 15.5191 -23.5701 -6735 6 12.6648 26.6033 21.3782 33.3074 -46.6123 -64.9668 -6736 4 12.0344 25.8976 21.5501 -12.6652 14.4466 17.403 -6737 4 12.7392 27.3327 21.935 -15.9008 39.2731 46.5109 -6738 6 47.0171 36.3051 29.9756 -14.9097 -3.99946 59.7783 -6739 4 47.3887 37.0247 30.5306 -0.120183 -5.44251 -19.0377 -6740 4 46.4147 35.8463 30.6463 22.302 11.6315 -30.1098 -6741 6 0.299553 12.7005 23.3858 -50.0817 10.3486 20.6993 -6742 4 0.55843 11.8154 23.133 6.9712 -0.709946 -9.28769 -6743 4 54.2783 12.6185 23.429 39.7411 7.62342 -2.706 -6744 6 54.1651 18.9185 21.5773 -27.3575 7.2555 -32.8787 -6745 4 0.055729 18.801 21.8215 42.2187 -10.4087 33.76 -6746 4 54.2632 18.7361 20.6344 -21.3012 2.13243 0.141772 -6747 6 25.7162 24.2884 23.7449 23.2111 -33.139 -2.25213 -6748 4 25.1836 23.5617 23.2944 18.61 24.747 21.927 -6749 4 26.5708 23.8587 24.0884 -36.4232 14.4676 -16.0896 -6750 6 11.8952 29.0236 26.8796 9.31073 -5.31833 9.58593 -6751 4 12.582 29.6684 27.1204 -3.01706 -1.21814 -5.31042 -6752 4 12.0145 28.319 27.5465 -5.16863 11.8863 -12.5997 -6753 6 48.0052 35.8598 10.6996 -18.0426 -22.591 -32.4945 -6754 4 48.7896 35.6794 10.1443 -7.64403 10.0758 9.7343 -6755 4 48.2747 36.3464 11.4544 19.4818 11.8303 20.3364 -6756 6 47.6544 29.8545 36.9555 47.7155 -39.8456 -42.9298 -6757 4 48.1196 29.373 36.1789 -16.9409 17.9192 43.9777 -6758 4 46.9556 30.2951 36.4995 -17.6283 12.0501 3.0439 -6759 6 7.32865 12.3513 10.6225 -20.3459 13.1064 -14.334 -6760 4 7.20572 12.8267 9.76478 7.03806 -14.4953 16.449 -6761 4 6.49136 12.5857 11.0944 24.1086 -12.0498 -8.15528 -6762 6 52.9256 15.9641 4.89737 -18.3283 -2.7411 -11.4996 -6763 4 53.001 16.1105 3.94443 2.36662 -0.713792 8.85774 -6764 4 53.8018 16.0105 5.25645 21.1817 2.44507 8.14275 -6765 6 10.6731 16.9472 34.6118 -36.7423 -4.99845 -47.4494 -6766 4 11.0533 16.8484 35.4724 -5.12202 -12.2675 26.0308 -6767 4 9.83371 16.4151 34.3796 40.245 18.7583 25.5995 -6768 6 25.147 31.0596 36.0152 -5.60145 -19.7687 -32.0201 -6769 4 25.7935 31.7656 36.1171 1.22463 2.78419 -3.72446 -6770 4 25.3418 30.5949 35.1615 -4.38154 15.6016 24.1358 -6771 6 34.0913 21.8858 41.4775 -4.76405 18.1665 32.5634 -6772 4 33.6625 21.1007 41.1787 -2.29922 -28.5955 -6.85504 -6773 4 34.6054 22.1733 40.7506 14.2114 10.2598 -30.2937 -6774 6 15.7731 30.0818 1.26798 39.0641 -13.3599 -49.0464 -6775 4 15.0823 30.4241 1.791 -23.818 19.5269 30.6537 -6776 4 16.2108 30.862 0.84325 -15.3415 -19.24 18.755 -6777 6 29.5302 27.8609 16.6022 -41.3972 -29.0796 28.0786 -6778 4 29.3307 26.8764 16.753 17.6765 42.2449 -1.67193 -6779 4 28.8227 28.3009 17.156 20.6394 -5.21731 -15.3441 -6780 6 39.6438 9.77612 0.552706 9.07327 13.2864 29.0584 -6781 4 40.129 10.5839 0.897097 -15.1313 -20.9808 -12.8857 -6782 4 39.4906 9.23066 1.36029 2.34479 9.54176 -15.0004 -6783 6 1.51524 31.8825 16.4089 -15.0842 0.567558 32.708 -6784 4 2.11225 32.2249 15.7721 17.5465 17.6302 -23.3114 -6785 4 1.56386 30.9485 16.2687 -0.663138 -25.5376 -6.36093 -6786 6 8.73078 39.8635 25.0545 2.96185 -34.7465 -17.9129 -6787 4 8.00321 39.5602 25.6169 4.07363 9.59654 5.53067 -6788 4 8.89391 40.7829 25.2096 -1.06312 24.7623 5.36493 -6789 6 42.3301 10.2778 9.76455 0.0249942 22.0437 -8.66619 -6790 4 42.035 10.1947 10.6715 6.68889 -4.55788 7.04955 -6791 4 42.6957 11.1854 9.68656 -1.85544 -15.7885 0.75259 -6792 6 13.241 7.61416 1.95847 -11.6175 -6.73398 30.6404 -6793 4 13.9892 7.82191 2.54806 -1.36929 5.6022 -7.80568 -6794 4 12.5695 7.22502 2.56499 11.7798 7.16895 -16.7116 -6795 6 18.7434 40.0583 14.2212 10.8937 -7.32712 21.4541 -6796 4 19.2417 39.7541 15.0131 -1.99408 15.6159 -18.1773 -6797 4 17.935 39.549 14.2832 -4.44855 -3.57314 -3.37042 -6798 6 20.0977 14.0454 38.5561 35.4799 -67.417 -7.49733 -6799 4 20.2641 13.632 37.67 -9.31749 10.6865 24.2255 -6800 4 19.7827 14.877 38.3297 -23.7972 64.5272 -8.60678 -6801 6 22.6565 28.8842 34.0588 -5.52315 8.37947 20.7951 -6802 4 23.0585 28.228 33.4828 2.77778 -4.34029 0.307399 -6803 4 22.9395 28.703 34.9822 0.354749 -6.57221 -14.6515 -6804 6 22.6874 4.70198 5.2328 -25.042 -9.90055 15.5414 -6805 4 22.1274 3.9708 5.56882 12.1557 -0.0327816 -16.8284 -6806 4 22.5434 5.31639 5.94822 12.9551 16.3877 4.62095 -6807 6 23.6492 33.9942 38.3998 23.375 33.8394 -43.1733 -6808 4 22.8011 33.6715 38.57 -44.227 -25.7371 21.164 -6809 4 23.4749 34.4069 37.5183 19.103 -7.547 16.6445 -6810 6 48.374 21.3549 17.2744 -0.727013 41.2048 -23.9838 -6811 4 48.2041 22.3166 17.0448 3.0192 -25.1475 26.0409 -6812 4 48.3509 20.9743 16.3868 -2.31832 -8.94154 10.8829 -6813 6 11.5758 10.9938 8.63273 -18.0621 42.8191 15.9647 -6814 4 11.6313 10.2483 9.25156 -2.19238 1.01339 1.87179 -6815 4 11.0547 11.7764 9.03291 21.9333 -36.8133 -6.7089 -6816 6 40.0924 28.1686 33.4857 17.1635 -5.37387 30.2378 -6817 4 41.046 28.3881 33.5354 -13.2006 -3.32107 -11.2861 -6818 4 39.7443 28.4933 32.6629 4.51627 6.28126 -11.3213 -6819 6 47.3837 25.6703 5.29617 28.7657 21.9065 -4.48206 -6820 4 46.461 25.5322 5.12569 -20.8862 2.51482 -4.893 -6821 4 47.6179 26.6114 5.08959 -12.3293 -15.1007 -0.275896 -6822 6 21.6517 35.2222 23.996 27.7917 10.3485 -3.89698 -6823 4 21.6311 34.5383 24.6593 -10.5502 -12.8786 6.64496 -6824 4 22.5954 35.4881 23.9966 -15.7417 2.23004 -2.6139 -6825 6 8.24409 41.4919 8.41354 9.22969 12.4334 -12.8549 -6826 4 8.15 40.8674 7.67873 -1.07657 -2.81584 5.48771 -6827 4 7.83543 41.113 9.18983 -1.52095 -3.2343 5.88405 -6828 6 16.4798 31.1082 22.2131 -4.24513 -17.8742 -2.35359 -6829 4 17.0752 30.8161 21.5077 -7.18137 4.28218 -7.0656 -6830 4 17.0564 31.1902 22.9696 5.97679 -0.907857 10.4567 -6831 6 54.7122 0.459271 28.3177 -16.7834 -37.5181 -6.57119 -6832 4 0.641958 0.15455 28.3975 4.09167 16.1916 -1.73275 -6833 4 54.5379 1.34634 28.6236 20.797 14.6923 4.72985 -6834 6 48.4477 15.3762 4.17752 -7.35125 -30.0531 -4.44848 -6835 4 49.1738 15.1128 4.81019 -14.8803 0.337287 -24.8229 -6836 4 48.0902 14.5922 3.6288 23.2827 31.0113 24.8784 -6837 6 34.3541 7.00171 40.4295 26.6588 -46.9533 -23.8625 -6838 4 33.6168 6.99428 39.8319 -14.4938 10.2897 -3.98371 -6839 4 34.9839 6.35967 39.9588 -19.3291 28.4488 24.7248 -6840 6 41.3507 3.37676 17.0028 -19.6969 -26.4955 -6.96819 -6841 4 41.02 2.66518 17.5936 5.53648 12.9859 -1.78552 -6842 4 41.944 3.90566 17.5305 10.5068 9.85924 8.73726 -6843 6 48.4427 20.685 14.5419 46.8112 -36.6841 26.4704 -6844 4 48.0177 21.3487 14.0717 -32.7597 47.8552 -32.6818 -6845 4 49.3877 20.9188 14.5227 -9.08294 -4.43462 -1.64124 -6846 6 52.4922 28.1277 37.1182 6.87418 8.84651 -10.3419 -6847 4 53.4134 28.4024 37.0408 3.12987 -6.6922 4.15316 -6848 4 52.2752 27.8963 36.2007 -7.47166 7.06161 9.73328 -6849 6 53.8774 18.5638 18.79 -18.2161 -77.5341 7.0005 -6850 4 54.7018 18.1425 18.5274 3.76082 -0.315502 -3.76089 -6851 4 54.0435 19.4528 18.7445 16.4561 77.5259 -2.54699 -6852 6 41.0011 39.1407 28.7879 -31.3786 -4.09579 71.7092 -6853 4 41.3911 39.2094 27.9661 28.9736 8.71878 -68.6315 -6854 4 40.0521 39.3021 28.7019 -2.27612 -3.41331 -6.23213 -6855 6 38.2743 8.75074 24.2285 24.5029 -7.68366 -19.8132 -6856 4 39.1919 8.60362 23.8621 -28.3827 4.68959 18.7737 -6857 4 38.3545 9.42009 24.9092 0.456349 2.35846 11.2764 -6858 6 2.99111 29.1615 9.6319 43.2691 -54.6401 14.341 -6859 4 2.5338 28.6319 8.99687 -12.0219 1.86489 -18.3516 -6860 4 2.58318 29.9865 9.638 -27.8835 49.5023 8.75508 -6861 6 27.5756 29.2755 18.3378 -4.01048 -11.7045 41.1881 -6862 4 26.7643 29.1652 17.8389 -11.7278 -2.11582 -9.62984 -6863 4 27.2839 29.0037 19.2864 20.9622 13.2114 -52.0932 -6864 6 11.8501 21.1733 10.1172 4.58733 -51.566 26.4002 -6865 4 12.2099 22.0246 9.9906 13.4732 33.828 -10.0235 -6866 4 12.4495 20.7458 10.776 -15.5727 16.0367 -15.8372 -6867 6 16.9004 32.2989 0.299881 0.133752 -22.2186 -6.7835 -6868 4 17.7029 32.7095 0.626455 9.4749 11.3588 3.4417 -6869 4 16.2118 32.9605 0.285394 -3.66285 20.1796 -4.1714 -6870 6 1.30064 17.4766 22.5523 32.9941 -5.4384 -19.965 -6871 4 1.2446 16.5356 22.2294 -6.1018 21.6977 3.5382 -6872 4 2.22906 17.8023 22.3815 -23.7878 -13.737 8.2324 -6873 6 41.5474 6.85538 29.3077 15.2611 30.5857 3.861 -6874 4 41.7413 5.96016 29.5642 -1.91107 -14.5726 0.121693 -6875 4 42.0251 7.37916 29.9826 -12.8279 -1.76094 -5.06557 -6876 6 10.5087 10.782 13.8577 27.0965 -13.6956 13.3978 -6877 4 10.7007 11.2274 13.0253 -2.16043 3.73872 -7.98734 -6878 4 11.2742 10.169 14.0479 -24.5023 11.0776 -3.5626 -6879 6 39.8289 15.4978 40.8346 25.2099 1.13818 0.661387 -6880 4 40.0487 16.0673 40.0758 -9.90377 -2.84048 2.34508 -6881 4 40.6829 15.4254 41.3222 -18.4618 6.82556 -4.74882 -6882 6 26.5164 19.6052 40.5088 -9.33805 1.61856 -11.7217 -6883 4 27.41 19.9717 40.4897 0.274496 -7.70925 5.49567 -6884 4 26.4209 18.9712 41.2422 6.64723 7.57269 5.06511 -6885 6 54.036 8.18782 13.7715 27.5212 34.9045 -2.54262 -6886 4 54.5316 7.46918 14.1378 9.61628 -19.3806 0.327355 -6887 4 53.1925 7.88218 13.5309 -39.9219 -15.1658 -7.5943 -6888 6 15.6949 25.3434 10.6718 -31.7842 -7.37099 0.0612328 -6889 4 15.1805 25.3333 9.84403 14.6699 1.30202 -4.92807 -6890 4 14.9666 25.3615 11.3188 15.8696 -4.15214 -3.47235 -6891 6 18.5987 3.44175 21.9294 71.7321 -9.69418 15.9409 -6892 4 19.6071 3.44542 22.1959 -64.1569 1.8736 -14.3483 -6893 4 18.6296 3.58776 20.9721 -7.77871 5.49431 4.81248 -6894 6 50.8883 20.6265 18.5187 28.1172 41.6529 17.9746 -6895 4 50.1573 21.1733 18.1958 -9.23125 -9.06144 -4.34911 -6896 4 51.4834 21.2842 19.0045 -23.468 -29.5191 -15.1667 -6897 6 53.3673 20.9038 31.2869 -12.1652 -1.18869 -3.23134 -6898 4 53.2409 20.9073 32.2442 5.88471 -1.70994 -0.407299 -6899 4 52.4717 20.8062 30.9053 11.2743 1.61965 3.90294 -6900 6 52.8102 27.6189 28.9831 -34.4743 -7.30027 30.0453 -6901 4 52.2848 27.4362 29.7987 1.4862 0.901255 -27.4551 -6902 4 53.4947 28.1361 29.3473 35.4934 25.3811 1.80223 -6903 6 33.3112 15.6955 11.3264 12.7704 9.00306 37.7013 -6904 4 33.4999 16.1238 12.2198 -3.00415 -23.4283 -28.8796 -6905 4 32.4346 16.0003 11.1059 -7.33456 8.94646 -4.12361 -6906 6 20.3875 26.8057 27.4813 21.213 -4.31231 15.2493 -6907 4 19.6396 27.3594 27.2578 -2.8557 9.66202 -0.370116 -6908 4 20.9667 27.2946 28.1279 -24.4059 -13.8952 -19.2793 -6909 6 8.54399 2.06163 14.1713 4.36483 17.1543 -0.299448 -6910 4 8.13837 1.20516 14.196 -9.47708 -17.773 2.17407 -6911 4 8.01805 2.60085 14.7902 6.78451 -6.83093 -3.12033 -6912 6 40.1002 7.56575 40.6778 12.4019 9.60944 38.6013 -6913 4 39.712 8.14959 41.3779 4.03526 -4.70584 -30.6789 -6914 4 40.8329 7.16354 41.1893 -8.78874 -6.51591 -16.4763 -6915 6 6.89044 6.83556 10.7869 16.1514 15.8461 -3.23426 -6916 4 7.31622 7.70217 10.5979 -16.164 -15.6489 3.8938 -6917 4 7.04178 6.69918 11.735 -3.2221 -0.411834 -4.21297 -6918 6 31.2643 6.58983 20.136 22.5576 -57.6677 6.94967 -6919 4 30.6637 5.92034 20.5005 -2.47046 2.78164 8.35653 -6920 4 30.7152 7.30056 19.9711 -35.0351 52.1138 -11.6241 -6921 6 54.5411 21.0454 27.2925 4.1013 -43.0328 84.8338 -6922 4 0.071192 20.2129 27.5399 -15.6737 30.1382 -21.2093 -6923 4 54.6532 21.3072 26.4181 12.1035 8.54749 -60.3726 -6924 6 4.75213 23.1508 16.2245 -49.4139 4.34438 -28.0546 -6925 4 4.2471 24.0009 16.1592 20.3634 -17.2761 5.59937 -6926 4 5.4972 23.3136 16.7675 27.2932 5.42097 22.4316 -6927 6 25.5515 11.0241 14.8358 9.2665 0.546345 5.2197 -6928 4 26.0976 10.3608 15.3182 -9.73323 12.0118 -14.516 -6929 4 25.8683 11.8947 15.1133 0.0398252 -5.90721 -2.6003 -6930 6 41.1974 41.7784 29.942 -27.7855 -7.97533 -10.6302 -6931 4 40.9203 40.8727 29.6366 8.3922 29.767 6.72032 -6932 4 40.4023 0.465719 29.8931 18.9924 -15.525 2.17149 -6933 6 52.2793 15.2936 41.6313 19.4314 -9.06844 -20.2837 -6934 4 51.991 15.9601 0.331443 -10.9307 10.9541 10.4228 -6935 4 51.6032 14.6231 41.5544 -13.8311 -6.7739 0.824233 -6936 6 37.7418 21.7882 37.8505 9.73059 24.2058 3.49681 -6937 4 37.8176 20.8655 37.6583 6.26781 -24.8638 0.142384 -6938 4 38.1128 21.8753 38.7352 0.661952 0.248137 2.40564 -6939 6 23.8436 9.73697 27.5598 -17.3101 -56.824 -21.1542 -6940 4 23.6823 8.97924 26.8635 13.0753 42.6322 38.797 -6941 4 23.3674 9.48178 28.3892 6.27388 8.11738 -19.7561 -6942 6 43.0121 28.0431 32.8137 29.5034 -18.022 1.83467 -6943 4 42.9555 27.148 33.1715 -16.7807 6.42622 4.12236 -6944 4 43.9561 28.0675 32.5908 -15.6612 14.0802 -2.62256 -6945 6 34.1451 21.2362 11.9042 -10.4207 -39.0944 -3.26361 -6946 4 33.7785 20.3444 12.1585 8.75301 27.3815 0.918114 -6947 4 33.7383 21.3833 11.0382 -2.92284 10.3561 2.31655 -6948 6 10.5016 31.8267 10.0873 5.91889 6.7472 5.74276 -6949 4 10.9186 32.6594 10.3946 -11.2895 -14.4825 -9.55855 -6950 4 9.99233 32.0033 9.274 9.03923 7.50024 8.93884 -6951 6 35.8744 37.1309 22.1208 9.07655 -0.20125 -37.6945 -6952 4 36.7757 37.5102 21.9868 -16.2539 -8.14962 7.83623 -6953 4 35.5893 37.243 23.0078 -0.963312 7.56509 34.0991 -6954 6 27.293 4.59192 27.4599 -62.9251 -2.97268 8.43797 -6955 4 27.8573 4.63875 28.2367 1.75868 -0.322614 6.7695 -6956 4 26.3027 4.46726 27.7774 60.9698 2.85981 -12.9146 -6957 6 39.0165 22.2861 10.6525 -25.2911 9.99335 20.5692 -6958 4 39.5938 21.9801 9.97437 16.8498 -5.94336 -19.6369 -6959 4 38.1468 22.3658 10.2352 2.38909 -7.32087 0.337973 -6960 6 30.765 39.1813 10.9358 -26.8864 17.0789 0.421318 -6961 4 31.7273 39.1993 11.0368 0.254075 -10.0442 -6.8497 -6962 4 30.3957 38.288 10.8473 24.5485 -0.522695 0.476538 -6963 6 44.5972 26.9475 2.20695 17.6159 -27.9211 -0.145864 -6964 4 44.8477 26.0903 2.61727 -13.9349 20.2639 -7.87324 -6965 4 45.3006 27.0404 1.55025 0.322606 15.9 1.66232 -6966 6 23.7817 14.549 26.4845 -13.1218 37.1912 -28.6876 -6967 4 23.5085 15.1786 25.7375 18.3344 -26.327 26.4977 -6968 4 23.2314 13.7794 26.3439 -3.10125 -8.02717 6.138 -6969 6 38.3349 13.3785 39.6531 51.0719 11.8768 18.627 -6970 4 39.1134 13.8424 40.1004 -28.3003 -20.0613 -21.9332 -6971 4 37.637 14.0102 39.7945 -20.9869 -1.09015 1.55638 -6972 6 17.9076 17.2343 29.3998 2.5182 -11.8623 9.07057 -6973 4 17.7005 16.8028 28.5679 -0.208052 -3.06359 -6.42367 -6974 4 17.2973 17.9612 29.4206 -13.3644 14.2602 6.84169 -6975 6 17.427 29.8312 9.9167 5.70667 9.14636 11.5297 -6976 4 16.5259 29.8398 9.63655 -18.5043 -5.93208 -2.5299 -6977 4 17.9097 29.6705 9.11934 16.3543 -3.78316 -10.6623 -6978 6 35.6302 6.05705 19.6249 -12.632 -1.17761 -30.1407 -6979 4 35.1756 5.57436 18.904 4.12491 -0.359791 14.6292 -6980 4 35.7342 6.9119 19.1826 9.40393 1.91765 12.7562 -6981 6 18.674 22.2857 17.523 8.42296 3.39096 21.1197 -6982 4 17.7402 22.4481 17.6821 -9.17854 0.615652 -6.61815 -6983 4 18.8674 22.3747 16.5992 -7.41694 3.44878 -20.9034 -6984 6 20.0258 3.81405 32.2871 -5.45876 10.2161 0.982716 -6985 4 19.684 4.03807 31.424 -2.67861 3.00481 -7.64614 -6986 4 20.9375 3.54321 32.099 -1.59169 -5.33194 9.42598 -6987 6 5.47094 6.98417 8.10987 -1.95658 -27.204 5.03178 -6988 4 5.85072 7.84658 8.088 3.96324 28.039 -6.11929 -6989 4 5.94584 6.55919 8.82772 -3.50663 -6.33739 10.9422 -6990 6 44.182 20.5312 25.5979 43.1361 -13.705 -19.148 -6991 4 44.6875 21.1042 26.1493 -15.9255 27.6084 29.7698 -6992 4 44.9726 20.2272 25.1253 -26.0739 -14.4287 -20.9555 -6993 6 43.9621 36.9892 17.8709 27.7049 17.1418 -9.42399 -6994 4 44.6647 37.4643 17.3692 -13.724 -4.61297 12.4448 -6995 4 43.6121 36.3808 17.225 -14.1002 -14.0328 0.985329 -6996 6 34.6183 10.1148 16.2555 -4.96303 14.2933 -37.1542 -6997 4 34.4099 10.1014 15.264 7.63186 -7.52385 38.4141 -6998 4 34.6455 11.0716 16.4378 1.03434 -4.81203 3.48645 -6999 6 23.6535 3.43617 1.32551 9.32991 -27.0385 -60.023 -7000 4 23.5361 2.47498 1.09872 1.70789 26.2755 24.74 -7001 4 23.8607 3.79652 0.414552 -11.3127 6.44054 37.9529 -7002 6 33.4225 38.9606 5.09116 -45.0556 15.9463 14.7537 -7003 4 32.9187 38.171 4.91655 10.2233 -24.4058 -4.43744 -7004 4 32.6531 39.5198 5.39063 34.9247 3.3662 -8.43025 -7005 6 22.5542 32.508 35.8091 -1.62577 21.6885 -22.4452 -7006 4 23.4313 32.1432 35.8321 13.5304 -8.64793 9.08541 -7007 4 22.6972 33.4304 35.4917 -7.91418 -12.6316 15.6694 -7008 6 32.4209 37.2696 13.8263 22.6153 37.4816 -15.7005 -7009 4 31.6314 36.8608 13.5507 -35.0264 -17.3769 -13.0658 -7010 4 32.7321 36.7183 14.5153 12.3601 -27.6025 17.2047 -7011 6 52.6048 12.7515 39.5965 -13.8302 -6.28036 -1.32475 -7012 4 53.26 13.3571 39.2655 9.70847 9.80763 -6.22213 -7013 4 53.0114 12.2827 40.3245 7.10516 -3.61819 3.538 -7014 6 28.8284 14.5654 1.23244 38.3097 18.383 -14.9432 -7015 4 28.2834 13.8143 1.34735 -23.3809 -22.0338 3.15251 -7016 4 28.3672 15.33 1.56727 -9.74512 0.414323 3.22557 -7017 6 1.45359 32.4205 23.3989 -1.05001 -40.1011 -18.1189 -7018 4 1.47013 31.5606 22.9188 -1.41837 10.7967 19.8874 -7019 4 1.97354 32.9442 22.8182 11.5552 29.203 -12.5869 -7020 6 54.3296 23.3325 28.9716 1.50467 4.34178 0.834044 -7021 4 54.2574 22.8567 29.7964 -0.193368 0.82753 11.1745 -7022 4 54.4723 22.6371 28.331 0.325397 -5.40149 -8.07104 -7023 6 14.3127 12.1509 35.6633 -33.5663 -10.8168 -13.6472 -7024 4 14.2878 12.7047 36.4184 6.74358 21.3133 20.6565 -7025 4 15.1756 11.8015 35.6107 35.8459 -8.25269 -4.05635 -7026 6 18.9986 6.53226 41.2771 -21.1361 -24.8418 -24.3627 -7027 4 18.366 5.78703 41.1105 9.63211 18.6573 18.8829 -7028 4 19.3119 6.48514 0.272589 3.11598 2.01554 11.5533 -7029 6 5.32991 17.8836 20.3428 -30.4167 16.0599 6.69424 -7030 4 4.7967 18.411 19.709 2.93149 -9.05217 4.33299 -7031 4 4.77097 17.8526 21.1546 15.0176 4.61027 -13.5236 -7032 6 24.7236 34.9657 30.1688 -3.59195 -26.0802 -14.261 -7033 4 24.7803 35.9013 30.0428 5.00342 21.1487 3.94382 -7034 4 24.6904 34.5809 29.2706 1.13339 13.2018 12.9935 -7035 6 31.868 4.6188 18.1813 26.0749 -11.7783 -2.21043 -7036 4 31.7807 5.26575 18.8694 -2.85928 14.415 8.06415 -7037 4 31.0011 4.54965 17.8036 -17.7428 -0.954819 -5.29079 -7038 6 8.70915 17.4782 5.92977 -5.10088 36.478 0.166614 -7039 4 7.99285 18.1665 5.8727 10.0003 -20.7449 -0.10219 -7040 4 9.53277 18.014 5.87919 -8.17468 -12.6369 7.06335 -7041 6 29.8448 10.9674 14.467 -9.24737 10.8237 6.24964 -7042 4 29.3518 11.4625 13.8111 -3.5417 -3.22768 -11.9456 -7043 4 29.8741 11.602 15.1948 7.6561 -6.41884 12.5924 -7044 6 48.7193 10.2987 32.5837 48.7914 -16.5053 -5.27468 -7045 4 48.664 9.84191 33.449 -1.5926 15.0761 -9.20872 -7046 4 49.6917 10.1556 32.2801 -49.2626 10.4163 8.33251 -7047 6 8.33128 15.6672 37.865 4.36755 4.12409 -33.9682 -7048 4 8.08142 16.0688 38.661 -6.22033 14.9054 48.1983 -7049 4 7.78443 16.1766 37.2488 7.82296 -4.92397 -7.06368 -7050 6 50.3849 3.07587 17.3306 53.0616 0.797084 -5.54454 -7051 4 49.9901 2.96071 16.4818 -23.7547 4.5323 -14.3202 -7052 4 49.831 3.21284 18.0832 -29.2444 4.71684 15.357 -7053 6 14.687 38.3962 10.9034 11.8452 2.26847 -28.7684 -7054 4 14.4993 38.5723 11.8231 -13.1425 0.700252 11.382 -7055 4 14.2628 37.5785 10.602 -2.45756 1.24341 13.1034 -7056 6 34.1174 6.37976 10.8168 12.9161 5.50138 13.5595 -7057 4 34.1292 7.23477 10.3416 2.23773 -14.4836 1.59416 -7058 4 34.9287 6.34152 11.3848 -14.7297 9.70771 -12.8953 -7059 6 7.1619 37.5492 17.6341 50.2032 -5.81562 0.15107 -7060 4 8.17599 37.5098 17.465 -47.7372 -0.307972 7.49553 -7061 4 7.05745 37.0565 18.4805 -8.53445 9.44148 -12.9936 -7062 6 51.515 11.3168 16.7982 -26.0757 5.86397 -27.0874 -7063 4 52.235 10.8459 17.1551 30.0977 -19.3818 20.7126 -7064 4 51.5008 11.0547 15.8562 -2.22905 10.0255 8.80825 -7065 6 15.6633 8.64974 3.19872 2.04011 -21.0584 -36.8111 -7066 4 15.359 9.2987 3.81038 -7.3063 19.0886 25.5551 -7067 4 16.1924 8.00887 3.67257 5.32849 -2.14206 7.59436 -7068 6 5.43671 21.4488 11.9213 -35.1135 30.2715 2.68526 -7069 4 5.1197 22.3031 11.5306 26.1226 -15.3225 -1.30607 -7070 4 4.71321 21.2794 12.5494 12.8867 -7.97314 3.40019 -7071 6 50.1888 24.041 37.9733 -16.5158 11.6838 -8.72192 -7072 4 49.5513 24.2503 37.2525 13.6843 -9.6942 16.9361 -7073 4 50.7608 23.3204 37.7156 0.52347 -2.66969 -5.08066 -7074 6 39.7366 11.2383 31.6978 23.7892 31.0409 -10.9794 -7075 4 40.3477 11.919 31.322 -8.85632 -23.7146 9.45819 -7076 4 38.8907 11.643 31.516 -11.7678 -2.00245 1.00495 -7077 6 26.6862 10.831 20.5846 -4.64528 13.8134 22.6501 -7078 4 26.37 11.3609 21.3584 5.46785 -6.26709 -23.7021 -7079 4 26.5097 9.94471 20.9062 3.28762 -9.42115 -6.7075 -7080 6 12.5617 17.5693 18.1619 57.3415 -16.6047 -35.4946 -7081 4 12.3732 16.6356 17.927 -10.1847 12.7431 11.2408 -7082 4 11.9536 17.9401 18.7496 -47.3477 6.23269 31.2745 -7083 6 47.7779 31.603 17.3345 -16.0229 -2.6295 -18.0517 -7084 4 48.4774 31.3981 17.9449 0.342859 -12.7175 10.4199 -7085 4 47.3751 30.7658 17.0144 6.51745 15.1025 2.87388 -7086 6 1.06661 3.38166 18.5387 0.482315 1.39351 -20.5486 -7087 4 1.47214 3.81044 19.3024 -7.19452 2.23946 8.83247 -7088 4 0.121217 3.21323 18.6865 2.92702 6.89788 10.7589 -7089 6 26.5916 20.3882 15.3141 4.05487 -19.1164 -7.10575 -7090 4 27.0276 19.5492 15.0037 -7.93965 16.9744 10.3813 -7091 4 25.6772 20.1067 15.4922 9.40368 -0.641397 -3.80974 -7092 6 42.0092 3.03717 36.7607 9.58516 7.42569 -27.539 -7093 4 41.472 2.27114 36.5289 -4.68032 -10.5632 12.6255 -7094 4 41.9749 3.27199 37.6769 -10.2045 -8.66607 25.0137 -7095 6 39.3197 22.4482 33.2161 17.1359 -6.1719 -1.11969 -7096 4 39.6777 22.5385 34.1471 -14.6651 4.73191 -34.7467 -7097 4 39.2891 23.3308 32.7977 1.66572 -7.01471 12.3298 -7098 6 18.4983 34.959 11.9233 -52.4092 11.8234 -6.15541 -7099 4 19.3311 34.9297 12.2931 62.358 -5.27325 28.8625 -7100 4 17.9525 35.2018 12.6795 -15.7268 -2.39727 1.11957 -7101 6 22.849 14.1156 0.206953 9.43339 -22.8796 20.8561 -7102 4 23.1273 14.7687 41.4941 9.338 18.1693 -9.76493 -7103 4 23.4344 14.2183 0.991573 -8.36464 7.13735 -11.7533 -7104 6 31.0127 16.6435 33.7717 -75.3989 -12.3916 10.6429 -7105 4 30.4261 16.8588 33.0132 20.7291 0.745933 12.1228 -7106 4 31.8948 16.7604 33.5238 39.9201 13.7608 -15.1754 -7107 6 28.4056 35.5121 5.54765 -4.91817 12.0412 -0.933493 -7108 4 29.0647 34.8486 5.74161 15.0982 -5.96625 -1.02933 -7109 4 28.8561 36.3656 5.44297 -1.6946 -6.58589 1.12865 -7110 6 2.06022 31.4415 10.6404 20.6415 1.38777 10.2498 -7111 4 2.4899 32.1989 10.2195 -2.44284 -2.19106 -3.22737 -7112 4 1.13111 31.6267 10.6164 -17.6565 -0.143118 -7.1498 -7113 6 5.95467 9.75858 21.3545 2.17354 8.87983 -50.8842 -7114 4 6.2643 10.5435 20.7894 -11.3634 -34.5597 22.4005 -7115 4 5.48441 9.14719 20.7121 9.8282 23.6666 23.1144 -7116 6 24.7866 26.6177 2.6661 -24.4024 -28.5469 2.9707 -7117 4 23.9476 26.6963 2.18158 9.10826 11.4817 -7.6186 -7118 4 24.6214 25.7954 3.1805 15.5163 19.2379 2.11057 -7119 6 45.7515 4.24664 18.6084 -0.948574 6.19926 2.59566 -7120 4 46.4738 4.91595 18.5123 -9.05862 -19.7882 -0.326833 -7121 4 46.0843 3.34349 18.421 4.31178 15.089 3.21664 -7122 6 4.45878 0.783326 15.9106 20.8465 2.39674 -2.22601 -7123 4 4.33336 41.7534 15.8294 -11.1347 -14.3847 -2.31303 -7124 4 5.37758 0.813141 16.2285 -10.0444 13.1447 -0.149196 -7125 6 2.44065 19.4988 25.3899 -18.2163 -19.9205 28.2208 -7126 4 1.89428 18.9873 26.0273 4.60516 17.0002 -8.33323 -7127 4 2.55045 18.8717 24.6878 9.48029 -1.77855 -17.0048 -7128 6 40.6027 8.48954 5.10826 -27.6355 -21.4881 -13.6167 -7129 4 40.6592 9.31425 5.57088 10.9479 16.5697 14.8472 -7130 4 41.3781 7.96424 5.30637 14.4251 2.68711 -2.52113 -7131 6 49.3092 22.3481 41.5186 -9.93734 74.0457 16.0776 -7132 4 48.4971 22.7919 41.1786 21.3857 -10.289 -0.267672 -7133 4 49.2285 21.4633 41.2985 -4.59952 -62.95 -16.8011 -7134 6 0.364483 40.9333 20.5966 -24.8933 -11.8265 -30.66 -7135 4 0.190818 39.9667 20.5681 4.35782 8.08342 1.06674 -7136 4 54.6936 41.3396 19.9676 13.1862 -7.22974 19.6204 -7137 6 34.8864 15.3279 38.0452 -17.1782 37.3505 -55.2903 -7138 4 34.2682 16.0872 37.9321 5.94042 -16.3876 6.60377 -7139 4 35.3697 15.4116 37.1797 -1.56134 -6.74346 24.1748 -7140 6 7.76223 25.9987 29.8652 25.7268 -8.51605 -4.95409 -7141 4 8.61839 26.4638 29.9588 -13.1921 -1.71741 1.7916 -7142 4 8.05672 25.0651 29.9772 -19.4202 16.3818 3.54783 -7143 6 40.7182 22.7954 20.4441 37.8127 13.8011 -33.8007 -7144 4 41.3586 23.4588 20.0133 -28.9149 -26.2189 23.8294 -7145 4 40.2017 23.2969 21.0583 -10.7099 15.3396 13.8501 -7146 6 37.6932 25.6399 36.0638 4.62997 10.0285 35.1853 -7147 4 38.3287 24.9236 36.1183 -2.20273 -4.01008 -9.65359 -7148 4 37.2914 25.6394 35.2107 -7.09628 -5.12362 -31.4654 -7149 6 5.46101 24.0014 10.2586 17.9799 16.5872 6.22131 -7150 4 6.04134 23.844 9.49543 -11.5162 -2.35388 5.85767 -7151 4 5.90746 24.7967 10.672 -23.415 -30.7572 -16.8601 -7152 6 48.4104 21.0451 38.1819 10.5351 27.9197 -28.7006 -7153 4 48.793 20.7803 39.017 13.2175 -6.38321 0.209366 -7154 4 49.1228 21.3802 37.5459 -28.8109 -18.4864 30.6779 -7155 6 15.2906 25.011 3.54101 2.70625 6.69817 -9.95824 -7156 4 15.4569 24.0555 3.50682 -9.52162 -0.514188 6.9158 -7157 4 14.6826 25.2483 4.2581 -1.83637 -10.9582 1.3864 -7158 6 46.3949 40.2718 20.0841 3.05266 -42.5213 0.389481 -7159 4 46.7282 39.319 20.1688 -17.5494 37.8624 -2.40649 -7160 4 47.138 40.8016 20.3323 14.2597 18.5668 -0.122304 -7161 6 34.6662 36.4732 0.324161 -52.0076 35.1593 -1.38074 -7162 4 34.82 35.9689 1.09464 17.4812 -18.6855 30.1307 -7163 4 33.7817 36.8781 0.601954 33.7085 -7.09846 -24.72 -7164 6 52.5968 8.00424 30.4116 -30.791 -5.83914 -1.44892 -7165 4 52.0396 8.66036 30.8559 12.8564 7.40177 -0.477247 -7166 4 51.9287 7.58179 29.8369 22.2614 -6.63703 0.63559 -7167 6 32.0772 3.86049 29.4688 -16.0025 -7.01815 -35.05 -7168 4 31.5382 3.03776 29.5615 20.8838 14.671 -1.22835 -7169 4 32.0904 4.03293 28.4798 -1.86833 -11.5506 40.3284 -7170 6 20.363 17.8245 28.646 3.47804 13.7512 -7.92665 -7171 4 19.5516 17.4966 29.0653 6.53113 9.74715 -6.36853 -7172 4 20.0825 18.3002 27.8308 0.555567 -8.90179 15.8758 -7173 6 30.4041 41.1634 41.0132 -16.7253 12.0993 -9.83452 -7174 4 30.5197 40.835 40.1072 4.71307 -5.7925 7.34595 -7175 4 31.1703 40.9637 41.5368 18.7313 -7.07732 1.06037 -7176 6 35.4542 32.8539 27.9215 21.6406 26.5455 -21.3275 -7177 4 35.1435 33.2362 28.7432 -6.21594 5.85967 7.97646 -7178 4 35.8745 33.6007 27.3754 -13.2283 -32.0923 16.9769 -7179 6 14.39 6.67952 12.731 -12.5058 36.491 0.424373 -7180 4 15.2321 6.28981 12.9462 8.74388 -6.1299 -2.75421 -7181 4 14.5067 7.66796 12.7988 -3.69921 -34.1177 -6.56265 -7182 6 41.8739 41.5433 20.319 24.4238 12.2951 6.29746 -7183 4 42.7192 41.2715 19.9184 -11.0628 6.38436 -6.30872 -7184 4 41.3184 40.7767 20.2955 -10.4459 -12.1473 -5.48062 -7185 6 46.3985 22.5739 8.8638 6.84921 19.3184 1.79378 -7186 4 45.8729 21.8991 8.42669 -3.07803 -12.5032 3.12866 -7187 4 47.1271 22.1566 9.33065 -8.50589 -8.34396 1.5145 -7188 6 17.4023 20.6526 13.9004 10.6995 28.5611 -11.4854 -7189 4 17.6978 21.6036 13.9579 -8.84666 -31.3302 7.07381 -7190 4 17.3123 20.5004 12.9448 0.490636 -3.23538 4.08121 -7191 6 8.20126 9.48382 13.3485 -42.4293 41.8522 17.2798 -7192 4 7.44487 10.0964 13.6076 19.5538 -29.8853 -13.4391 -7193 4 8.9576 10.0119 13.6277 13.7224 -9.45646 -1.54211 -7194 6 7.58554 14.8008 29.5824 -2.61798 9.90858 -2.64866 -7195 4 7.05733 14.3538 30.2458 -0.514214 1.68252 7.63674 -7196 4 7.01989 15.5029 29.2149 4.91731 -6.06465 -0.976267 -7197 6 29.5668 39.2268 22.6285 -3.66094 -2.39634 13.3419 -7198 4 29.8353 38.7557 23.4169 -4.20308 -7.76017 12.2752 -7199 4 30.3745 39.2765 22.1369 12.5997 4.36069 -18.8462 -7200 6 19.725 28.7952 8.44488 15.8543 2.58223 -4.45186 -7201 4 19.5131 27.8757 8.63421 -2.81313 1.38303 -4.16069 -7202 4 20.6983 28.808 8.54393 -13.7447 6.84799 3.59225 -7203 6 20.0995 21.6275 25.9249 -17.5249 50.4223 5.09745 -7204 4 20.7082 22.0204 26.5908 -8.84326 -18.264 -10.6066 -7205 4 19.3931 22.3347 25.9239 13.215 -30.9895 -3.48111 -7206 6 12.7711 16.1006 22.7986 17.0661 -2.75106 -3.7002 -7207 4 12.1316 16.7784 22.5952 -11.3059 6.43976 -4.8982 -7208 4 12.4647 15.3033 22.3372 -2.13756 9.04884 6.71194 -7209 6 7.09175 27.2069 17.991 -23.617 26.2366 -1.29155 -7210 4 7.8076 26.6007 17.9383 20.2011 -26.8554 -5.74897 -7211 4 7.19403 27.792 17.2318 3.33647 -0.0238245 -0.788587 -7212 6 32.3975 8.68618 34.8629 3.54321 22.8272 16.3539 -7213 4 32.7738 9.06402 35.707 -18.9002 -9.48773 -27.5474 -7214 4 31.4989 9.0701 34.6771 23.7457 -9.58556 9.46102 -7215 6 50.3515 28.2186 17.5351 -6.87553 0.519429 12.9107 -7216 4 50.2481 27.3572 17.999 6.5408 9.8464 -12.2276 -7217 4 51.0722 28.1417 16.8919 -2.26653 -7.3618 -1.59066 -7218 6 15.6741 32.1546 25.7968 -26.4348 -11.0143 -14.9159 -7219 4 16.4004 32.6083 26.1805 24.7846 13.6092 10.6573 -7220 4 15.1411 32.8481 25.3674 4.92309 -4.07512 11.5217 -7221 6 41.2877 22.001 29.6411 43.1174 -21.5596 15.2505 -7222 4 40.6305 22.5901 29.3541 -33.8214 23.827 -16.0773 -7223 4 40.8662 21.2212 29.998 -7.36398 -2.60921 4.02408 -7224 6 24.5416 12.7608 8.88206 5.17198 -11.9982 -20.3907 -7225 4 24.1774 13.5122 9.35398 1.69504 4.6425 -2.53241 -7226 4 24.2888 12.8675 7.94212 1.28664 -3.68024 15.0016 -7227 6 47.3025 20.1085 10.3977 1.21439 24.4816 37.2747 -7228 4 48.204 20.4596 10.4656 -0.7364 -8.12719 -10.3932 -7229 4 47.15 19.5905 9.61989 6.68365 -16.152 -23.0167 -7230 6 17.6916 14.2112 29.9613 0.736848 4.98565 -22.9932 -7231 4 16.8377 14.622 30.0672 -16.7241 9.37988 10.4211 -7232 4 18.1183 14.7557 29.2835 1.70081 -6.05446 6.16757 -7233 6 21.3481 34.5805 28.5342 -9.54463 9.82799 -20.865 -7234 4 21.5933 35.4178 28.0943 -1.05427 -4.62886 14.5387 -7235 4 21.7361 34.566 29.3968 13.4346 0.0141216 16.9261 -7236 6 35.1024 4.03924 4.01172 -45.5158 42.5484 12.3245 -7237 4 34.1858 3.89939 4.38295 32.1954 -12.7538 -7.33111 -7238 4 35.1016 5.02916 3.89259 9.91862 -26.8751 2.91657 -7239 6 29.9059 8.58368 22.6013 -13.5917 -22.6535 -48.6732 -7240 4 29.4773 8.30259 21.7189 15.3855 19.7125 42.6195 -7241 4 30.4378 7.8025 22.8052 -0.87874 9.41284 8.39762 -7242 6 9.78314 32.9658 15.9197 34.9354 -36.2496 39.6827 -7243 4 9.8463 32.0623 16.3137 -14.5131 14.3099 -26.4053 -7244 4 10.4229 33.3707 16.5321 -2.5459 17.7355 -14.0184 -7245 6 24.9212 14.2335 32.582 19.5351 -17.8621 25.1352 -7246 4 25.485 14.4356 33.3711 -14.9506 -0.509299 -20.0473 -7247 4 24.5508 15.0526 32.2925 -5.32053 16.7872 -6.18619 -7248 6 49.6539 21.965 26.2345 44.0267 25.2751 -8.97422 -7249 4 50.4399 21.435 26.5572 -22.3889 20.3635 -4.11669 -7250 4 50.0214 22.8598 25.9362 -18.5294 -37.2714 15.3372 -7251 6 39.2165 29.6282 28.7804 -1.72389 1.82743 -9.11301 -7252 4 39.3036 29.0201 29.5259 1.24025 -1.09654 1.55877 -7253 4 39.538 29.1266 28.0158 0.286751 -1.49672 5.82908 -7254 6 50.6899 34.7862 39.7499 25.3157 10.1005 12.0928 -7255 4 51.6472 34.6743 39.5192 -19.7186 -4.86584 -0.193213 -7256 4 50.1651 34.2508 39.1591 2.72681 -14.2758 -14.8682 -7257 6 29.2004 20.8742 19.5261 27.9811 -3.68804 20.7377 -7258 4 30.1466 21.1247 19.5553 -9.39276 -2.96688 2.79863 -7259 4 28.9246 21.1497 18.6738 -22.5466 15.5983 -24.0329 -7260 6 45.8438 1.42491 21.3861 -37.1737 6.40486 -10.0566 -7261 4 44.9885 1.11968 21.7285 6.97513 -0.0444158 -7.72874 -7262 4 46.4438 0.92117 21.8904 34.782 -15.8409 16.3481 -7263 6 26.1011 5.84859 12.9885 -16.9285 4.46913 -7.38549 -7264 4 26.5547 5.08441 12.6375 7.71787 -14.9735 6.0022 -7265 4 25.1614 5.66972 12.8036 4.71997 0.43883 -1.19571 -7266 6 9.00669 19.0403 23.7238 12.8928 30.373 -14.6892 -7267 4 8.06593 18.9071 23.7945 -12.9763 -5.98489 5.20443 -7268 4 9.0473 19.9093 23.2431 5.0983 -22.172 6.64837 -7269 6 47.6961 14.1782 40.0269 19.0377 9.97795 -11.4729 -7270 4 48.5222 14.3512 39.5239 -16.7083 -4.37767 10.6105 -7271 4 47.3795 15.0553 40.2888 -5.04524 -6.44815 -3.81417 -7272 6 47.9985 19.7874 0.500962 -66.9165 -27.0064 -39.4066 -7273 4 48.5513 19.9496 1.22397 26.1904 -2.55385 45.3318 -7274 4 47.2789 19.103 0.704655 34.6798 29.0788 0.973802 -7275 6 27.1606 39.6013 31.4318 -10.4761 -55.491 -38.6851 -7276 4 26.8926 40.2811 32.0159 -13.7359 20.3686 20.1783 -7277 4 26.3709 38.9998 31.2101 25.3937 25.349 18.055 -7278 6 20.7209 15.2822 27.3078 -0.805435 -7.71632 -8.78017 -7279 4 19.7876 15.3781 27.0487 8.25469 13.9731 2.34115 -7280 4 21.2532 16.0335 26.9925 -16.2498 2.55153 -4.46604 -7281 6 53.2722 3.12643 19.6849 41.3384 49.6686 7.26214 -7282 4 52.533 3.74254 19.7043 -8.02663 -2.92583 -3.0848 -7283 4 53.0086 2.23956 19.6703 -22.4403 -46.3419 -2.11618 -7284 6 40.7531 33.3786 24.0219 13.5521 -1.60379 23.9632 -7285 4 41.5067 33.1664 24.6167 -8.75803 3.71621 -14.936 -7286 4 40.1104 32.6626 24.1628 3.50492 2.6284 -2.95087 -7287 6 50.2066 37.8896 21.3771 44.4561 61.7722 -19.2089 -7288 4 50.9779 37.3435 21.496 14.3962 -14.5259 7.12428 -7289 4 49.4598 37.4098 21.5582 -59.0635 -51.549 13.7135 -7290 6 41.3233 2.3412 21.9924 -16.3503 12.7858 19.6024 -7291 4 41.3426 2.52207 21.0679 5.97541 2.4567 -21.4637 -7292 4 40.4663 2.75609 22.2585 17.532 -18.0725 0.252127 -7293 6 3.68867 21.2779 14.3383 -14.5707 42.5 -35.9941 -7294 4 4.12477 21.855 14.9587 9.56216 12.6885 8.47194 -7295 4 3.77328 20.4352 14.6935 9.76412 -50.205 23.6517 -7296 6 34.2782 11.1533 36.6146 -6.03132 -23.9347 13.7336 -7297 4 33.9924 10.5436 37.3334 13.9996 -4.78487 -21.5854 -7298 4 34.1172 11.978 37.0322 -7.62349 27.2634 9.28858 -7299 6 24.0533 21.9225 23.4615 4.73517 -5.47775 13.1649 -7300 4 23.9978 21.53 22.5886 6.00444 -6.53009 -8.74438 -7301 4 24.605 21.2935 23.9896 -10.4931 14.2472 -9.63662 -7302 6 18.8931 0.346665 4.41951 -1.70081 19.9518 7.76538 -7303 4 18.8368 41.3461 4.13842 4.04101 -8.25805 2.22226 -7304 4 19.3845 0.416823 5.25819 -4.2619 -8.11151 -12.0763 -7305 6 1.61167 7.82777 17.7295 14.4633 -7.55708 2.21629 -7306 4 1.68315 6.88308 17.5181 0.421421 7.02752 -3.81945 -7307 4 0.776664 7.94842 18.1735 -9.56642 1.01884 2.20602 -7308 6 9.88587 31.542 26.4865 27.4574 -58.0414 -32.6279 -7309 4 9.74723 30.8294 25.7579 9.18818 32.443 34.13 -7310 4 9.16596 32.1271 26.4328 -35.6644 31.0992 -1.66616 -7311 6 46.989 33.006 20.3636 -11.9681 -37.8677 44.1235 -7312 4 47.0707 32.5253 21.2626 7.56487 31.1056 -35.1941 -7313 4 46.435 32.3629 19.8924 4.61548 9.19147 -10.8851 -7314 6 49.5457 29.2916 21.3977 -38.7846 4.15079 -24.0209 -7315 4 50.3477 28.8236 21.2219 24.323 -7.55681 13.7085 -7316 4 49.5468 29.8542 22.1736 14.9668 -0.936193 10.2574 -7317 6 13.5153 31.8979 19.1528 13.8675 8.3184 29.6787 -7318 4 12.8458 31.9825 19.8587 16.0999 2.21739 -7.32054 -7319 4 14.3406 32.2634 19.5906 -25.0701 -6.26478 -24.6616 -7320 6 46.633 34.1066 16.9257 -0.036059 -36.1463 20.7227 -7321 4 46.8492 33.9929 15.9997 3.99258 8.43366 -10.882 -7322 4 46.9059 33.2223 17.3084 -4.9703 29.3867 -9.59361 -7323 6 19.7609 39.5392 2.42166 -7.20248 -0.896063 -14.0911 -7324 4 20.5606 40.0527 2.5788 -3.5749 4.99115 -1.28658 -7325 4 19.2738 40.0463 1.72337 11.6568 -15.7424 21.4794 -7326 6 16.5329 9.39795 28.3065 -12.6095 -8.72502 6.68605 -7327 4 16.4075 10.3536 28.3648 10.1088 3.80195 -3.74389 -7328 4 17.4502 9.20269 28.1082 11.2813 2.72217 -1.81406 -7329 6 3.0433 33.3643 8.96425 -4.92886 23.6682 -21.9772 -7330 4 2.41869 34.0757 8.74286 -2.57616 0.180013 17.6579 -7331 4 3.16376 33.0029 8.08154 7.55925 -16.3918 2.91827 -7332 6 49.6751 28.308 0.201579 -29.5359 7.30765 2.58258 -7333 4 50.5733 28.3754 41.8671 34.4717 0.327786 -9.88202 -7334 4 49.5726 27.4715 0.657175 -2.26504 -2.01296 8.34302 -7335 6 1.41619 6.84354 30.4994 -10.3235 0.0954103 3.42179 -7336 4 1.63397 7.74222 30.8225 4.19995 -13.4757 3.05915 -7337 4 0.761793 6.45905 31.124 14.5617 20.0187 -8.0296 -7338 6 19.7679 9.42131 33.717 -3.22882 -6.25654 -44.8315 -7339 4 19.9145 8.46604 33.7746 1.8774 1.59257 2.48781 -7340 4 19.5751 9.55831 32.7323 1.24521 6.76178 40.819 -7341 6 26.1724 11.919 3.61074 17.7641 10.7445 -19.8393 -7342 4 25.5356 12.1934 4.24073 -14.9718 14.8208 22.8097 -7343 4 26.0423 10.983 3.54915 1.55706 -20.7566 2.99847 -7344 6 33.2542 2.1444 18.2116 -1.15587 48.9982 3.93816 -7345 4 32.886 2.96086 18.6548 6.67205 -21.4839 -22.8104 -7346 4 32.6761 1.46025 18.493 -13.9253 -19.4899 6.26155 -7347 6 1.55797 29.1194 15.6221 -22.3111 36.2637 61.7506 -7348 4 0.853719 28.5449 15.936 -7.71843 6.28063 0.384394 -7349 4 1.90648 28.6788 14.9107 30.7784 -39.3832 -62.5327 -7350 6 41.7311 4.10421 39.5944 -40.7328 36.7616 -42.7174 -7351 4 41.3817 4.81242 38.923 27.6667 -38.3892 36.6931 -7352 4 40.9025 3.64602 39.8145 11.2401 -8.56921 5.26404 -7353 6 28.6823 41.7982 21.1955 47.2047 1.42594 -8.59686 -7354 4 29.177 0.720645 21.3267 -21.6507 -0.473723 0.486784 -7355 4 29.4617 41.2314 21.0003 -26.4876 -3.65191 3.02858 -7356 6 11.643 12.3982 35.4482 -35.2927 22.3423 -20.2863 -7357 4 11.5968 12.2307 36.3713 6.75035 -5.55932 30.2124 -7358 4 12.5522 12.401 35.2267 32.0712 -2.0845 -6.40416 -7359 6 9.80556 12.056 0.297197 42.0735 31.0338 -28.3715 -7360 4 10.6577 12.4693 0.65483 -33.0881 -22.384 -10.4034 -7361 4 9.20254 11.76 0.941289 -12.1624 -10.8407 36.4861 -7362 6 48.1632 12.393 9.2137 2.43833 7.21341 -5.5951 -7363 4 48.4522 11.811 8.50685 -9.57081 -7.25037 -8.94466 -7364 4 48.8896 12.3474 9.83523 7.41749 2.43397 12.8852 -7365 6 20.1331 24.378 18.9556 11.9182 2.36756 -38.9603 -7366 4 19.4372 23.8368 18.5171 17.2732 8.77886 9.60074 -7367 4 20.7988 24.6336 18.2364 -23.7637 -10.2166 26.3276 -7368 6 16.5494 31.2838 16.4573 -15.9423 3.69088 33.2062 -7369 4 16.5519 32.1922 16.7594 11.1434 16.9832 -11.781 -7370 4 16.1476 30.8867 17.2522 1.55385 -15.8871 -15.2552 -7371 6 1.78983 14.6435 36.2904 4.99553 5.58283 2.2492 -7372 4 1.04893 14.2282 35.8708 -13.8588 -3.35469 -16.6141 -7373 4 1.66905 14.392 37.2023 2.39459 2.07051 19.2387 -7374 6 4.37166 29.2153 29.5914 5.79168 20.1405 -19.3585 -7375 4 4.91557 28.7254 30.2154 7.17051 0.117226 5.39869 -7376 4 4.91513 29.9512 29.1891 -14.7291 -26.607 12.32 -7377 6 43.6969 0.237019 22.6594 -7.19613 -4.49497 -5.57098 -7378 4 43.0237 0.783547 22.2316 -12.2242 -6.81623 2.03469 -7379 4 43.4415 41.2053 22.5454 5.15142 14.113 -1.35906 -7380 6 52.5052 40.9917 27.2414 -4.0762 -16.2903 -30.037 -7381 4 52.8129 40.7577 26.3208 -10.5132 10.5144 20.9332 -7382 4 53.295 41.2999 27.6882 6.37269 9.42971 1.77711 -7383 6 25.5785 23.9088 27.7352 -29.163 -0.147769 2.09076 -7384 4 24.7169 24.3904 27.6009 26.0068 -16.0483 4.45096 -7385 4 26.303 24.4711 27.4736 4.98376 5.99744 -3.44082 -7386 6 23.1322 17.0409 33.3147 -4.87562 4.34963 6.5261 -7387 4 23.1435 17.5188 34.1474 -0.665908 -2.26574 -1.07751 -7388 4 22.9237 16.1327 33.5379 -5.85649 -9.89669 4.05086 -7389 6 2.9235 11.8719 21.3628 -62.5775 -31.8178 -28.2901 -7390 4 2.1985 11.2347 21.6738 31.4392 30.9604 -16.9464 -7391 4 3.51176 11.9111 22.066 35.7266 4.49799 37.8533 -7392 6 2.17958 4.14491 30.0321 9.06251 -9.53771 -13.2585 -7393 4 2.15165 5.09682 30.107 -1.56529 16.7016 0.150815 -7394 4 2.7299 3.97467 29.2422 -7.5281 0.377543 4.10315 -7395 6 26.6694 30.2855 13.4776 10.1196 11.7228 27.7054 -7396 4 25.7357 30.4785 13.6549 -0.51692 -11.2356 -3.98914 -7397 4 27.0778 30.3597 14.373 -6.55394 -4.70072 -25.9179 -7398 6 24.8731 30.8123 10.8246 -35.9544 -8.06722 -7.65859 -7399 4 25.2097 30.0125 10.4324 5.41746 -9.73411 -7.41209 -7400 4 25.6149 31.228 11.1936 31.2673 18.7081 18.3938 -7401 6 53.1638 24.1184 4.51161 -10.4445 -35.9395 21.0824 -7402 4 53.5233 24.7957 3.98549 14.2054 30.1141 -21.0763 -7403 4 53.9237 23.6117 4.81383 2.71167 2.31883 7.09562 -7404 6 24.8958 4.51213 23.9931 -29.6363 -43.6073 15.3227 -7405 4 24.1339 5.1036 23.9039 18.5944 16.8193 -2.99678 -7406 4 25.7258 4.88904 23.7461 22.8138 27.5954 -9.18982 -7407 6 34.6838 1.65591 41.2514 12.8053 -23.083 -29.6978 -7408 4 35.6244 1.45761 41.0729 -14.4971 0.421146 -0.177754 -7409 4 34.7301 1.99199 0.211928 -2.47028 17.9107 34.9925 -7410 6 13.312 19.5249 16.387 18.9594 -19.3284 17.3248 -7411 4 13.9333 19.1674 15.7225 -9.24732 -4.9188 0.52103 -7412 4 13.2597 18.8166 17.0929 -3.23838 18.5958 -24.3952 -7413 6 48.698 0.181353 20.409 -0.21633 -26.9433 -24.4133 -7414 4 49.103 41.5184 19.698 -4.34753 24.5911 30.5043 -7415 4 48.7986 41.623 21.2469 8.80211 1.41451 -0.511645 -7416 6 43.0644 27.7916 11.5133 -14.5871 -6.12813 -9.0892 -7417 4 42.6 28.0105 10.6776 10.2055 -1.97818 11.3293 -7418 4 43.4908 28.591 11.8257 3.55806 4.66568 -1.20709 -7419 6 25.6909 21.365 35.1834 16.6334 21.4278 -26.2382 -7420 4 25.8486 22.0441 34.4664 -6.54449 -15.4554 28.1071 -7421 4 25.5413 20.5536 34.6727 -4.24699 7.33591 15.2905 -7422 6 44.7232 4.60607 27.7619 9.66663 0.618053 -4.25407 -7423 4 44.3234 4.00717 27.1079 -6.11804 2.34462 0.765623 -7424 4 44.3971 5.50639 27.5932 -3.06611 -6.30885 -0.545657 -7425 6 41.2897 11.4432 34.2066 -9.61739 21.0206 -8.56292 -7426 4 40.6842 11.5664 33.4581 3.14959 1.41378 -1.0752 -7427 4 41.1924 10.5195 34.3892 0.589219 -23.8889 7.33677 -7428 6 19.897 36.6492 2.04794 -32.5825 5.5481 -21.6378 -7429 4 20.6399 36.2361 2.4987 10.0826 10.558 0.716761 -7430 4 19.9026 37.6342 1.97212 14.9366 -15.8518 15.2433 -7431 6 27.4836 4.66736 6.35028 2.97665 -65.4375 -50.0742 -7432 4 27.6123 3.82169 6.79207 -3.46759 -4.72632 -9.32934 -7433 4 27.4741 5.24116 7.04108 -4.39889 64.7262 58.0755 -7434 6 16.8382 30.7844 39.9326 10.6925 -56.0648 15.7324 -7435 4 17.0186 31.2572 40.7403 -2.33579 15.7179 12.0581 -7436 4 17.0831 29.8382 40.1617 -5.04661 27.4351 -11.6424 -7437 6 51.1641 15.1933 16.3324 21.7581 16.0625 -9.079 -7438 4 51.121 16.0888 15.8936 10.5188 -25.5533 9.6052 -7439 4 52.0677 14.7794 16.1385 -37.3149 17.1399 3.28502 -7440 6 49.9904 21.2241 35.9744 20.9503 -33.7397 19.542 -7441 4 49.3714 21.5088 35.3291 -23.4605 10.1211 -23.8745 -7442 4 49.9121 20.2362 36.0002 2.40052 26.2853 0.00810801 -7443 6 34.428 0.14016 5.66944 -7.82493 37.3161 8.31948 -7444 4 34.304 0.843366 6.34479 2.68801 -11.9822 -16.4886 -7445 4 34.2591 0.582485 4.80419 9.04141 -16.6905 11.7821 -7446 6 48.3182 11.536 19.8764 -48.9228 13.3726 26.2823 -7447 4 47.7285 11.3649 20.663 34.2262 -2.74449 -19.9886 -7448 4 47.7235 12.1441 19.3775 23.4884 -14.873 -2.11476 -7449 6 4.19152 39.4305 13.3555 27.463 28.0369 44.5079 -7450 4 4.88401 39.7456 14.019 -21.6239 -15.7277 -33.754 -7451 4 3.37287 39.6897 13.8148 -3.76347 -10.7833 -11.4512 -7452 6 8.74995 16.191 8.53596 -5.05856 2.64204 -21.058 -7453 4 8.7323 16.8633 9.22906 0.669847 -0.203387 -6.91741 -7454 4 8.69158 16.6347 7.64451 3.76071 -7.46014 24.9197 -7455 6 29.0285 14.2822 26.5262 -5.84817 34.0816 17.5192 -7456 4 29.0044 15.2824 26.745 3.30971 -49.1818 -9.92417 -7457 4 28.1563 13.9159 26.7584 2.39554 12.59 0.416474 -7458 6 27.3852 14.5292 8.14264 -25.3608 8.37865 0.80053 -7459 4 26.4121 14.3996 8.08331 21.4517 0.6706 1.76752 -7460 4 27.495 15.4908 8.29449 3.73212 -17.2528 -1.50339 -7461 6 14.1265 27.2071 32.922 33.1666 19.82 -10.1122 -7462 4 14.9257 27.349 33.4618 -9.56175 -2.66902 -6.75133 -7463 4 13.49 26.8422 33.5082 -21.5238 -13.7689 15.9353 -7464 6 31.6534 35.7886 21.2701 -36.804 -37.663 0.546332 -7465 4 32.1208 36.3742 21.8378 9.4961 28.0075 13.3964 -7466 4 30.8651 35.4592 21.7961 25.8489 11.2411 -16.1565 -7467 6 54.2152 28.7064 16.8886 2.86275 11.2554 8.9719 -7468 4 53.522 28.534 16.2345 -0.160695 -4.94794 5.34414 -7469 4 54.0581 29.6054 17.2296 -4.68599 -7.1814 -6.41975 -7470 6 9.06113 5.28333 17.1437 22.8853 4.22723 -20.1716 -7471 4 9.91678 5.17464 16.6036 -37.1561 0.754494 23.2593 -7472 4 8.77829 6.22091 17.0709 7.89423 -13.2605 2.73354 -7473 6 29.6746 9.78112 26.5507 33.4729 -21.3737 16.6755 -7474 4 30.5187 9.26436 26.5785 -19.9088 14.0899 -1.39861 -7475 4 29.3838 9.79264 27.4752 -2.64272 0.36338 -0.771294 -7476 6 44.0224 31.1718 32.1785 -15.3292 -7.28341 -3.2168 -7477 4 43.2245 30.9732 32.7283 18.2556 6.42044 -7.39667 -7478 4 44.6106 31.7763 32.6435 0.791193 1.46174 13.5451 -7479 6 53.5017 3.62335 25.1421 -16.9806 -9.67341 -1.19546 -7480 4 54.1073 4.37139 25.2408 5.33888 -0.871569 -8.36925 -7481 4 53.4976 3.25444 24.2353 14.6771 10.8199 10.1585 -7482 6 12.4523 22.8699 3.37515 20.8696 32.0548 51.3092 -7483 4 12.8715 22.0381 3.24611 3.69599 -28.8916 -15.1378 -7484 4 11.7545 23.0169 2.77653 -28.9409 -2.61743 -32.5554 -7485 6 39.4163 29.6883 0.716973 23.965 14.7498 -4.51132 -7486 4 39.9876 29.0776 0.254063 1.0023 1.05593 -7.22278 -7487 4 38.7356 29.138 1.03498 -27.9991 -12.2746 11.9106 -7488 6 13.7523 37.8126 23.0391 19.0421 33.8918 15.0049 -7489 4 14.5819 38.1972 23.3968 -5.92503 -31.5844 -9.82397 -7490 4 13.2717 38.649 23.0641 -23.8611 -10.9328 -14.9892 -7491 6 33.3489 41.2294 0.00543 12.0778 19.0207 4.12226 -7492 4 33.8966 0.076279 41.545 -17.8654 -16.3366 26.9287 -7493 4 33.5442 41.0956 0.968664 -4.79835 4.63337 -24.688 -7494 6 15.7246 3.52046 6.32841 10.9162 -8.85937 41.3038 -7495 4 14.9211 3.23468 6.78447 -0.787572 2.77727 3.3355 -7496 4 15.4617 3.69817 5.45032 -11.5336 7.63209 -33.5323 -7497 6 27.7759 30.762 5.08277 5.52432 -34.0682 -16.3389 -7498 4 28.5998 30.6312 5.57248 -10.7862 7.58152 2.34054 -7499 4 27.6688 29.856 4.68367 -5.5152 22.3618 6.77689 -7500 6 13.3283 7.58248 23.3427 28.3072 -1.43357 14.0598 -7501 4 14.1858 7.86415 22.9596 -10.8574 -4.57961 9.77565 -7502 4 12.7328 7.50745 22.6198 -18.1881 0.025746 -17.8687 -7503 6 38.3062 37.3234 27.9933 -3.63803 -3.21002 47.0561 -7504 4 38.1692 37.3862 27.0673 7.32148 -0.46048 -39.7323 -7505 4 39.0245 36.7163 28.2248 2.26391 -1.88339 -8.27891 -7506 6 35.8197 12.5511 12.093 -4.81482 -18.6185 14.0356 -7507 4 35.6024 11.6096 12.0486 2.81432 1.21601 -0.921604 -7508 4 36.2712 12.7262 11.2865 10.3444 9.98072 -18.0035 -7509 6 52.1161 23.0926 41.2793 27.7225 -3.87143 -59.8556 -7510 4 52.4049 23.0393 40.2964 5.44511 3.0042 51.4604 -7511 4 51.1968 22.9093 41.149 -26.7248 -2.75497 17.7375 -7512 6 39.5495 11.6692 16.6079 -1.17202 -14.5197 -14.1262 -7513 4 39.7784 10.7494 16.7482 7.99576 -7.98247 -12.1867 -7514 4 39.4663 11.9292 17.5115 -4.38422 20.0879 20.6825 -7515 6 0.676885 9.01905 7.96736 13.1741 22.7352 -22.4375 -7516 4 54.8016 8.92404 8.29683 -40.226 7.08621 2.19233 -7517 4 1.10058 8.31451 8.38908 28.7575 -30.4684 16.9583 -7518 6 42.3311 28.7401 39.4661 13.4879 80.877 11.2525 -7519 4 41.6603 28.5849 40.0851 -34.7426 -11.2721 27.5092 -7520 4 42.5519 27.921 39.1558 20.2132 -66.4303 -37.3003 -7521 6 38.7411 30.2829 16.2738 12.7671 5.32399 18.4704 -7522 4 38.9183 29.8748 17.1496 -6.87016 4.31697 -11.6029 -7523 4 39.4059 31.0046 16.2472 -14.9795 -12.5163 -3.03567 -7524 6 7.58764 18.0405 0.648325 -47.6574 -19.7672 20.3632 -7525 4 7.12731 17.6217 1.42737 12.1211 9.19751 -27.5752 -7526 4 8.47251 18.0259 0.938181 42.7013 4.4664 8.86021 -7527 6 33.7296 34.5938 24.1405 -3.484 -2.51034 -8.30179 -7528 4 33.5251 35.3309 23.5532 1.13599 -1.72579 4.26838 -7529 4 33.8994 34.9649 25.0137 6.47563 -1.63099 1.09862 -7530 6 16.0166 40.0494 39.5956 -28.3908 0.329345 -1.37751 -7531 4 16.9382 40.2323 39.4336 17.0381 0.329941 -6.23981 -7532 4 15.5262 40.0524 38.7513 12.3223 -0.591958 2.13513 -7533 6 4.49229 37.1333 21.8385 27.3085 -52.2253 -58.5501 -7534 4 4.66683 37.716 22.5264 18.8147 38.5231 40.56 -7535 4 5.37915 36.8768 21.3985 -41.7208 12.465 14.7942 -7536 6 39.2691 20.1288 31.3316 -12.2203 -9.20146 -18.9279 -7537 4 39.1503 20.9416 31.8094 1.95478 16.2675 16.373 -7538 4 38.6746 20.1785 30.5607 4.99665 9.53371 7.24081 -7539 6 28.5508 6.16368 32.0494 2.8072 -5.52183 -6.01527 -7540 4 29.3622 6.49582 32.4253 9.65206 -4.8896 7.96618 -7541 4 28.0782 6.98121 31.874 -4.3704 -0.58129 1.95425 -7542 6 9.33595 11.3298 38.1871 -32.8874 9.84086 11.8913 -7543 4 8.64445 12.0594 38.2922 21.8008 -26.7714 -10.0524 -7544 4 8.88851 10.5546 37.784 7.69784 20.5749 -6.72048 -7545 6 41.6095 10.4782 6.86111 8.23897 -6.62675 34.9169 -7546 4 41.7694 10.1037 7.78655 -4.1265 15.4661 -32.721 -7547 4 41.7821 11.4382 6.90291 -3.49967 -11.9299 -5.09907 -7548 6 3.12867 28.1157 17.6206 15.6267 -45.6796 29.9202 -7549 4 2.63816 28.6493 17.0564 -29.7899 29.6493 -43.0934 -7550 4 3.59757 28.7421 18.155 7.53462 9.15161 11.5693 -7551 6 39.3499 12.2397 19.2529 -23.7838 14.9837 13.9357 -7552 4 39.2457 13.2286 19.3464 7.91877 -27.4185 3.68816 -7553 4 38.6075 11.8387 19.7677 15.6586 5.94778 -12.3856 -7554 6 2.78491 9.11686 31.712 -26.5503 -22.4732 34.9375 -7555 4 3.2978 8.41451 32.2045 -9.27186 19.8876 -17.5091 -7556 4 3.27525 9.5282 31.0263 27.6548 6.40843 -16.0242 -7557 6 47.0993 34.3062 24.1668 40.213 25.5871 3.96938 -7558 4 47.8652 34.9011 23.9742 -8.40565 -28.0457 9.8184 -7559 4 46.4391 34.8642 23.795 -37.1496 -1.08965 -6.28687 -7560 6 41.29 35.6184 9.54316 -30.0867 29.8286 7.21591 -7561 4 40.3249 35.7138 9.72984 17.4159 -14.0538 -3.31523 -7562 4 41.5907 36.542 9.70742 6.71087 -21.892 -10.0971 -7563 6 20.4656 31.4513 3.14505 -29.4444 2.15246 21.5865 -7564 4 20.9799 31.2087 3.9226 8.79014 -0.482357 -2.15716 -7565 4 19.5517 31.5947 3.51954 23.5031 -1.57475 -20.844 -7566 6 33.2192 17.965 24.7971 19.8065 25.0952 18.1835 -7567 4 34.1598 18.0267 25.093 -16.2559 -11.4614 -7.96855 -7568 4 32.9244 18.9016 24.8301 -6.14071 -21.8705 -2.46334 -7569 6 40.1545 39.892 35.7566 -26.4952 1.03865 35.1005 -7570 4 39.554 39.7115 35.0283 3.12548 3.08468 -2.58895 -7571 4 39.5538 40.0617 36.55 23.7339 -1.54775 -30.4418 -7572 6 4.86493 34.7165 16.5037 -1.18866 4.83191 -8.79653 -7573 4 4.98021 35.6639 16.3239 -2.48039 -7.07182 -3.79473 -7574 4 5.57973 34.27 16.0245 9.17482 -2.77359 5.31354 -7575 6 19.1203 11.0308 26.5475 4.8369 12.9311 -1.38474 -7576 4 19.2948 10.8261 25.6303 -10.7878 -2.53157 -9.81197 -7577 4 19.6222 10.3806 27.0285 -0.932765 -12.0852 11.9627 -7578 6 54.013 13.9266 34.7866 19.735 -12.4153 18.0126 -7579 4 53.1377 14.0488 35.1524 -10.4928 -1.09871 -13.0068 -7580 4 53.982 14.1469 33.8595 -3.66316 10.2302 -11.2602 -7581 6 1.83695 20.649 5.20524 25.5491 14.9074 -17.0883 -7582 4 1.35705 19.8566 4.90021 2.5306 9.60758 -2.11708 -7583 4 2.48138 20.9466 4.48633 -27.5057 -15.388 16.1855 -7584 6 22.2484 0.089789 14.2543 15.3573 -11.1234 0.0573231 -7585 4 21.4821 0.622149 14.4313 -9.66168 8.29964 10.305 -7586 4 22.7606 41.8363 15.0657 -14.7435 5.42194 -5.09127 -7587 6 4.9437 7.03924 24.7311 13.2528 -2.19763 7.32506 -7588 4 4.13251 7.3412 24.2993 4.98795 -3.92941 -4.4547 -7589 4 5.31694 6.26419 24.274 -9.7854 5.58222 5.45409 -7590 6 41.4768 20.8727 34.9433 -10.8141 32.3245 17.6117 -7591 4 42.0721 20.1596 35.0936 18.2074 -21.2429 -2.25611 -7592 4 41.5511 21.3995 35.7803 -3.93981 -14.5735 -18.4651 -7593 6 28.2063 1.73787 31.7361 2.56856 -6.63991 -21.6427 -7594 4 27.5833 1.04583 32.0206 5.931 11.5306 2.70007 -7595 4 28.427 2.28487 32.4907 -6.15569 2.19681 12.1249 -7596 6 16.8959 27.3728 36.9936 3.36683 -9.46076 -21.7251 -7597 4 17.1861 28.0765 36.4018 -0.835984 6.87178 9.62195 -7598 4 17.1491 26.5677 36.4964 -8.72142 5.45523 11.8618 -7599 6 26.8172 38.095 8.33253 -7.04389 15.4319 43.7153 -7600 4 26.4231 38.1886 9.22965 13.1827 16.4204 -18.9623 -7601 4 26.752 37.1697 8.26194 2.82704 -45.8494 -18.5449 -7602 6 26.6605 33.8021 23.2109 -14.7721 -8.40788 6.86704 -7603 4 27.1437 33.2455 22.6071 1.71839 -3.83047 -13.3917 -7604 4 27.3181 34.0928 23.8234 13.6598 11.6313 12.8928 -7605 6 10.2089 27.1103 30.2249 26.5091 -20.839 -19.8889 -7606 4 10.2296 28.0525 30.305 -4.35446 23.414 7.17464 -7607 4 10.909 26.9135 29.5485 -17.3927 5.996 19.4297 -7608 6 47.8678 12.6068 5.01236 10.3402 17.2727 14.3835 -7609 4 48.2471 13.4466 5.34357 -15.5974 -13.1618 -9.91905 -7610 4 48.2827 11.9587 5.58273 0.760146 -12.24 2.37579 -7611 6 53.3401 24.5564 22.1447 -33.4845 3.13007 15.4457 -7612 4 53.2868 24.6175 23.1082 -8.50106 -5.88574 1.47389 -7613 4 54.2491 24.6404 21.954 37.9576 4.9603 -12.0283 -7614 6 29.4115 10.751 19.3682 47.3718 16.1602 -3.46693 -7615 4 29.23 9.95501 18.9095 -1.62259 -22.6341 -18.5903 -7616 4 28.6164 10.8767 19.816 -47.8248 15.8998 30.722 -7617 6 39.4772 14.9486 19.552 50.4126 11.9025 42.2912 -7618 4 40.3976 15.2789 19.8627 -47.7598 -21.1435 -8.50237 -7619 4 39.4723 15.2512 18.6704 -12.4406 15.8155 -35.6919 -7620 6 32.8813 15.9868 22.8125 3.47488 17.0872 -31.9433 -7621 4 33.0166 16.4922 23.6113 -1.39335 7.20309 14.6349 -7622 4 32.7144 15.0846 23.0256 -4.37432 -22.045 19.0968 -7623 6 30.558 1.96704 21.5074 2.70654 -4.91402 -0.473851 -7624 4 30.6739 2.00523 22.4671 5.88049 3.20632 -1.97238 -7625 4 31.3728 1.59666 21.1136 -11.8747 6.17773 7.16567 -7626 6 0.976021 12.0022 3.31788 -2.33791 2.9975 -11.3542 -7627 4 1.23381 12.945 3.27167 -8.13702 -10.1344 5.41434 -7628 4 1.05317 11.6593 4.21576 7.83216 6.74936 8.77967 -7629 6 32.1417 30.4028 20.7928 -10.9162 7.90477 -12.8705 -7630 4 32.9583 30.6218 20.3315 4.32484 3.35409 -0.814586 -7631 4 31.4267 30.7883 20.2371 10.7836 -11.8724 10.7529 -7632 6 5.37233 35.5196 8.9984 1.65786 -0.655334 17.0686 -7633 4 5.15633 35.7733 8.10502 -8.52999 -6.98357 -10.434 -7634 4 4.86772 34.7263 9.2434 -1.9757 2.02155 -6.9424 -7635 6 49.9125 13.0387 32.1973 27.4626 15.6741 -16.8517 -7636 4 50.6053 12.9182 31.4733 -26.2683 -0.306922 26.3637 -7637 4 49.2504 12.3613 32.0764 -3.75185 -11.6573 -0.304044 -7638 6 4.31386 24.093 1.57868 7.45772 -24.8618 -14.5348 -7639 4 3.64218 24.7342 1.7864 -13.9986 8.43803 -2.25361 -7640 4 4.01488 23.4668 0.872394 2.3276 24.3041 16.4513 -7641 6 44.1644 38.1215 12.3455 -22.0907 -25.3739 20.9172 -7642 4 43.5152 37.5597 12.8481 16.1408 4.83783 -17.5332 -7643 4 43.8688 38.9961 12.5721 5.21907 21.319 -3.3764 -7644 6 44.6817 17.3326 22.8013 48.0619 -4.56356 -9.07637 -7645 4 45.2902 18.0584 23.1498 -22.5072 -22.7727 -5.21409 -7646 4 45.2932 16.6008 22.4593 -20.015 30.0459 19.1644 -7647 6 20.3678 11.7042 19.6638 18.1083 -41.9451 -24.672 -7648 4 19.8947 12.3606 20.1264 -14.0753 36.8205 14.9866 -7649 4 20.5011 12.0109 18.7433 -0.799123 0.72776 10.7716 -7650 6 4.45477 15.3976 36.1886 1.65809 1.26145 11.9226 -7651 4 5.09661 14.6681 36.098 -4.75494 5.61497 -10.92 -7652 4 3.56051 15.0123 36.2095 4.93474 0.57137 -3.51241 -7653 6 44.8032 39.5214 30.1736 10.2403 3.65831 -28.7798 -7654 4 44.6649 39.352 29.2044 0.893291 -3.4354 28.9244 -7655 4 44.1834 39.0261 30.7164 -9.9549 -0.503639 -4.51595 -7656 6 30.0776 3.52093 11.3186 -8.111 -9.63673 -5.93937 -7657 4 30.5797 4.33725 11.0789 -10.9699 -19.7375 -4.73534 -7658 4 29.9808 2.85663 10.5812 14.022 21.906 10.2093 -7659 6 25.6241 24.8658 16.1333 6.68449 -9.57605 -29.1286 -7660 4 26.5694 24.8046 15.8818 -8.72523 1.1772 17.1704 -7661 4 25.5267 25.1318 17.0381 12.8553 5.85519 26.3055 -7662 6 36.8177 29.8487 20.6561 -37.5479 -3.0004 33.0202 -7663 4 35.926 30.1959 20.4157 18.2985 -1.907 -0.407745 -7664 4 36.6716 29.3784 21.5423 12.7247 15.2026 -39.3319 -7665 6 52.2186 17.0658 38.3042 -7.89215 -38.4825 28.5148 -7666 4 51.4916 16.4675 38.6484 24.7832 21.5941 -14.95 -7667 4 51.8247 17.6139 37.6469 -10.8917 8.73986 -12.7264 -7668 6 3.82879 23.6249 29.8747 0.0111461 24.9347 -0.194649 -7669 4 4.57266 23.2964 29.3507 7.82142 7.55197 5.89536 -7670 4 4.12107 24.4472 30.3626 -2.93665 -31.334 -6.69289 -7671 6 6.37221 19.8955 41.0814 -10.7405 10.6187 0.232117 -7672 4 6.67124 19.2607 41.7286 9.67887 -12.4754 3.81392 -7673 4 6.49825 20.7419 41.4991 -1.14685 10.1205 10.9238 -7674 6 28.9128 38.9237 35.3305 22.4394 21.6131 25.3888 -7675 4 28.4594 38.2476 34.8641 -13.9867 -26.2755 -20.0992 -7676 4 29.711 38.4973 35.7105 -10.7836 3.83713 -8.57645 -7677 6 1.06675 30.3059 34.4729 25.4378 -4.31804 35.0042 -7678 4 0.780778 29.8064 33.7399 -5.76855 -22.7951 -38.2413 -7679 4 0.490797 31.0506 34.5199 -18.1513 16.5028 -0.872558 -7680 6 26.4359 22.0299 20.4363 32.8101 13.5123 0.44111 -7681 4 27.364 22.3315 20.3938 -13.8894 -16.1779 0.0777322 -7682 4 25.9647 22.8561 20.3336 -19.4369 -2.2953 -2.32927 -7683 6 3.94837 18.6341 22.6823 32.7056 -17.0211 23.8668 -7684 4 4.7768 18.6814 23.2391 -24.3494 -8.73456 -16.7413 -7685 4 3.72444 19.5457 22.6416 -13.4357 33.3979 -9.86072 -7686 6 6.89585 39.3162 26.9832 -46.5714 7.68979 7.72716 -7687 4 6.93923 40.0377 27.612 28.7888 3.33438 12.9127 -7688 4 5.92214 39.2413 27.0287 16.4173 -5.75108 -11.0421 -7689 6 43.9872 41.7521 26.5322 17.8857 -12.0416 -16.5154 -7690 4 43.9509 0.2718 27.3768 -8.40653 9.77536 19.5266 -7691 4 43.1315 41.809 26.1188 -22.0408 9.50446 -3.00799 -7692 6 31.7113 29.5746 16.987 -20.6637 1.93471 5.13032 -7693 4 31.02 28.863 17.0135 12.5534 15.6398 -7.64726 -7694 4 31.2508 30.4156 17.2234 10.2038 -24.3383 2.42367 -7695 6 46.2561 10.9612 15.5385 0.577538 -38.7584 22.3134 -7696 4 45.3251 10.7213 15.4484 -5.02058 7.03855 -0.171485 -7697 4 46.6569 10.0824 15.7727 -2.20865 28.2857 -11.3723 -7698 6 36.5827 15.0435 25.8168 31.2067 4.61936 9.12499 -7699 4 37.3875 15.5118 26.1911 -33.209 -18.98 -14.6655 -7700 4 36.1295 14.6889 26.5897 -4.0863 -6.05063 3.58839 -7701 6 47.2722 22.6647 6.13576 -8.17133 27.0247 -35.749 -7702 4 46.6204 23.3224 5.77393 14.8224 -22.4366 13.8178 -7703 4 46.9842 22.4705 7.01441 -4.98592 -2.25738 16.061 -7704 6 27.5378 39.6651 17.8024 -2.94112 10.9701 -10.3343 -7705 4 26.5953 39.7232 17.618 -8.53785 1.10642 -8.0722 -7706 4 27.5664 39.1005 18.5557 5.38052 -12.9364 18.2146 -7707 6 14.0357 27.9675 36.8848 11.7171 -39.9071 2.25396 -7708 4 13.4367 27.1833 36.8225 11.7441 28.4062 -4.63591 -7709 4 14.9372 27.5486 36.8957 -17.1932 18.8386 1.76957 -7710 6 33.7684 13.0304 13.8649 26.1794 -24.2655 -33.187 -7711 4 34.6252 12.938 13.363 -28.3858 22.7045 20.1179 -7712 4 33.4338 12.1329 13.7478 -6.61414 4.24237 14.4002 -7713 6 3.3826 17.477 1.97134 -12.4208 -32.1468 -36.6933 -7714 4 2.99872 16.7111 1.40376 19.9781 39.313 29.0042 -7715 4 3.44044 18.2025 1.33186 0.336883 0.1642 8.16047 -7716 6 27.5407 2.76347 36.4361 37.1152 10.6125 -5.75272 -7717 4 28.1274 2.95293 35.6781 -8.18971 -2.06925 12.0999 -7718 4 26.7696 2.41682 36.0063 -15.232 -6.73967 7.66134 -7719 6 21.3092 1.20818 18.7198 27.6808 -56.7894 17.4302 -7720 4 20.9088 2.03925 18.6129 -17.8717 42.912 1.2548 -7721 4 21.1846 0.863131 19.6413 -10.5106 12.8119 -18.3621 -7722 6 11.8887 16.6751 29.3062 -13.3787 -14.7829 9.57092 -7723 4 10.9992 16.5416 28.8882 19.0949 3.10928 11.6713 -7724 4 11.8781 16.1991 30.1864 -3.15773 18.3703 -25.9576 -7725 6 15.9606 29.4505 29.6321 19.1231 40.0535 19.8704 -7726 4 16.8787 29.2659 29.409 -1.79459 -0.812108 -5.15406 -7727 4 16.0576 30.3074 30.1528 -10.887 -31.0851 -11.0284 -7728 6 42.9296 7.03459 4.51333 33.3286 4.63812 8.33203 -7729 4 43.4321 7.52085 3.82302 -14.3213 -8.56549 9.51251 -7730 4 43.6462 6.74019 5.1384 -26.8219 -5.28882 -15.1101 -7731 6 46.4281 26.3352 18.5118 -29.5226 20.9834 -10.3716 -7732 4 46.6343 27.1839 18.9751 -0.829481 -30.2492 -9.82569 -7733 4 45.6684 26.5824 17.9287 20.9241 -8.5113 7.46212 -7734 6 26.8394 31.9326 30.1088 25.5924 -16.6135 -32.4851 -7735 4 27.2107 31.0232 29.8435 -20.3392 35.4128 12.4615 -7736 4 26.6802 32.4017 29.2373 1.48159 -21.8349 29.7067 -7737 6 19.4878 37.6142 31.2562 -14.4543 3.58951 24.8148 -7738 4 19.156 36.8698 30.7235 -3.28844 3.66685 11.8368 -7739 4 19.1019 37.6358 32.1884 8.87174 -10.6544 -29.6345 -7740 6 52.3726 32.7139 12.8078 14.0751 37.5782 -32.6023 -7741 4 51.9367 33.0602 12.0031 -5.44932 -19.1877 9.81768 -7742 4 53.2329 33.1776 12.7347 -13.6236 -17.9256 14.0183 -7743 6 6.74161 9.28353 24.0307 -13.1667 -36.0519 9.75632 -7744 4 6.38029 9.61276 23.1997 0.718458 -3.76261 -6.90188 -7745 4 6.16941 8.51095 24.2946 11.6474 19.2019 -8.42102 -7746 6 39.7455 39.5612 25.4988 -8.346 1.54154 -0.59194 -7747 4 39.7035 38.6168 25.2826 0.975023 6.38379 0.651723 -7748 4 38.8484 39.7767 25.8082 2.0142 -6.85885 -0.770105 -7749 6 24.0762 14.0053 21.1456 13.3165 -18.5501 -35.6859 -7750 4 23.5798 13.5675 21.8237 -9.9014 -1.44375 19.5869 -7751 4 24.3047 13.2647 20.5221 -3.72657 29.1491 15.9401 -7752 6 5.19759 41.7876 24.8616 10.5329 -30.3401 13.9713 -7753 4 5.96107 0.070496 25.4117 5.01198 -1.48177 -8.04364 -7754 4 4.80364 0.70791 24.6471 -6.87058 19.426 -10.6286 -7755 6 42.3635 20.8692 21.2747 32.7502 -34.6644 -10.1673 -7756 4 42.4242 20.4785 22.1458 -3.583 2.66194 10.2144 -7757 4 41.7418 21.5604 21.318 -29.6652 28.4695 2.24145 -7758 6 48.2477 15.3659 33.5923 1.80889 -1.28345 12.5443 -7759 4 48.6164 14.6993 32.9992 0.330488 0.612282 -4.05403 -7760 4 47.6342 15.9182 33.1009 -4.13716 0.340872 -13.8372 -7761 6 46.021 38.2915 16.5867 23.3569 13.4435 24.034 -7762 4 46.6714 37.7063 17.0526 -15.1447 15.3639 -15.4724 -7763 4 46.2171 39.2064 16.9307 -10.1858 -20.2136 -16.2853 -7764 6 4.64649 28.484 21.3661 -49.4423 -36.8464 -34.122 -7765 4 5.0061 28.857 22.1388 17.5694 9.2675 37.6073 -7766 4 4.11403 27.6656 21.6036 24.8595 24.6655 -3.1651 -7767 6 20.5601 15.1658 18.389 17.6685 -18.4833 12.4376 -7768 4 20.0269 15.9148 18.1339 -10.4277 9.01273 0.992097 -7769 4 20.1375 14.696 19.1318 -1.87864 11.9594 -2.12399 -7770 6 16.2536 13.648 17.4664 -31.6255 -3.12789 -19.3987 -7771 4 16.1444 14.6075 17.6118 2.65347 -13.1818 -8.15029 -7772 4 15.6032 13.3943 16.7283 22.0135 11.6863 31.5082 -7773 6 52.4969 30.9511 18.1582 10.5176 -22.8935 27.2955 -7774 4 52.1187 31.5845 17.5724 -17.5669 13.4893 -21.7562 -7775 4 51.7599 30.5669 18.6706 14.518 10.6779 -8.97027 -7776 6 24.417 1.73185 15.7818 -6.46311 -4.24469 33.4298 -7777 4 24.2563 1.19981 16.5985 3.98325 2.24538 -18.7421 -7778 4 24.1038 2.61269 16.0335 4.13298 0.832539 -9.96215 -7779 6 23.8696 5.09384 31.0808 18.8621 -40.8234 -26.8653 -7780 4 23.8491 5.89936 31.5593 0.144588 30.2314 14.3891 -7781 4 24.8063 4.82715 30.9043 -17.3015 12.7186 6.18451 -7782 6 29.664 30.9246 0.393748 19.8337 -4.81556 23.0674 -7783 4 30.503 30.586 0.018652 -21.3617 6.75777 -1.54054 -7784 4 29.144 31.3327 41.6109 -5.17979 -0.628515 -14.2195 -7785 6 32.8496 37.8945 22.5158 10.0753 4.77658 10.1953 -7786 4 33.692 38.178 22.1563 2.67507 -3.41774 -7.7275 -7787 4 32.953 38.1222 23.4459 -10.6691 2.21895 5.00606 -7788 6 16.4801 17.3789 33.7607 -9.23434 -4.14589 -23.771 -7789 4 15.9446 17.8653 33.093 7.5539 3.01496 23.5583 -7790 4 17.136 16.9338 33.2029 1.0053 3.7812 3.66748 -7791 6 9.22576 13.3955 27.544 21.8484 -6.91303 -4.28818 -7792 4 8.36976 13.4851 27.1157 -15.2219 0.444174 10.4645 -7793 4 9.14931 12.9772 28.4181 -9.36318 7.36421 3.71477 -7794 6 43.4776 7.7356 17.2334 -9.59035 3.82748 19.1182 -7795 4 43.4092 7.74545 18.2218 0.501649 1.62452 -33.0026 -7796 4 44.4173 7.85634 17.0579 0.99974 -1.57098 -4.99047 -7797 6 22.314 24.3423 23.1668 -12.6246 5.51695 -1.93377 -7798 4 22.7955 23.5193 23.2443 6.83464 -10.1031 3.26418 -7799 4 21.5276 24.1384 22.6266 3.35813 5.31764 3.82921 -7800 6 26.0086 32.9187 32.7195 -0.756619 6.65713 -1.20686 -7801 4 26.2515 32.7095 31.8047 -0.82286 -4.52018 -0.557583 -7802 4 25.2078 32.4163 32.9092 -2.81033 -0.378904 -0.617388 -7803 6 16.9305 19.0463 7.44765 14.0068 18.7364 -6.96389 -7804 4 16.3855 19.2981 8.21028 -2.47769 1.30563 -6.88861 -7805 4 17.0815 19.8512 6.87677 -9.59141 -23.4241 18.196 -7806 6 48.1118 14.458 27.5672 -1.70385 5.14823 10.3583 -7807 4 48.0423 15.1786 26.9235 1.90686 -4.78611 -1.19899 -7808 4 48.0875 14.8765 28.4507 4.89589 -0.740891 -11.823 -7809 6 52.3863 41.7399 11.1185 2.41988 14.2085 23.7397 -7810 4 52.3863 0.193993 10.2459 -4.45976 10.8931 -22.0542 -7811 4 52.6887 0.557857 11.7005 -5.56281 -10.4239 -7.84704 -7812 6 36.3311 6.93589 12.7094 -2.38398 9.53491 -1.97617 -7813 4 36.3789 7.90344 12.827 -2.48918 -10.7733 3.15906 -7814 4 37.2588 6.6822 12.6726 5.22435 -7.00461 -0.877062 -7815 6 8.24215 20.3216 16.6719 4.98767 -5.10439 -5.65687 -7816 4 8.08588 19.3952 16.4038 -4.3079 5.82994 10.8424 -7817 4 9.2046 20.4438 16.7199 -1.30961 -3.63404 -4.19262 -7818 6 28.7954 40.3113 12.828 -13.6179 6.23593 21.4452 -7819 4 29.5192 40.3706 12.2287 20.8327 -7.3113 -16.8089 -7820 4 28.5554 39.3777 12.9053 -3.26344 4.60902 -2.65931 -7821 6 18.1473 11.8343 16.9395 -0.80483 -16.2761 12.6256 -7822 4 17.6848 12.6388 17.2294 4.62203 -2.59462 -3.9508 -7823 4 19.0947 11.9922 16.9221 7.13726 16.095 1.27241 -7824 6 30.8869 17.4142 21.504 -52.7305 12.2285 -31.3088 -7825 4 30.1482 16.8222 21.1884 27.1221 10.2955 22.0665 -7826 4 31.6253 16.8731 21.7262 19.9221 -18.6281 13.9623 -7827 6 34.8012 19.4194 37.9626 16.1869 22.0253 -15.6613 -7828 4 34.8979 20.1386 37.2822 -2.41662 -18.1877 20.3873 -7829 4 34.2105 18.7604 37.6043 -6.15487 -8.04615 -10.7113 -7830 6 35.8208 16.8923 29.2032 22.3367 20.7443 33.8648 -7831 4 36.613 16.5252 29.6466 -9.20578 0.119567 -6.22754 -7832 4 35.5382 16.2441 28.5922 -11.4717 -30.451 -21.7041 -7833 6 3.04279 32.2854 6.33929 -26.9238 12.3825 -4.69033 -7834 4 2.12647 32.146 6.0594 1.42689 6.59766 6.64942 -7835 4 3.42261 31.4611 6.08203 25.9982 -20.506 -0.598367 -7836 6 26.7966 41.6596 10.1464 32.6739 -10.8326 9.81865 -7837 4 27.6955 41.4226 9.79016 -25.5431 4.71255 4.81996 -7838 4 26.9918 0.01593 11.0584 -5.4334 2.64263 -3.14356 -7839 6 52.266 24.562 24.8685 -9.42886 0.421982 -6.72882 -7840 4 51.3046 24.7615 24.9057 17.7877 -5.82089 5.23086 -7841 4 52.6568 24.8699 25.6923 -4.67896 5.24225 9.60646 -7842 6 22.6938 22.6511 33.5751 -3.71591 7.58927 38.5179 -7843 4 23.2073 23.1628 34.2375 -1.81825 -3.74423 -24.5931 -7844 4 21.9227 22.4274 34.1227 -1.3969 -6.37714 -14.1968 -7845 6 10.6508 14.2453 33.0462 38.3111 -19.1724 1.31243 -7846 4 10.5904 14.9583 32.4175 -11.7628 10.624 -9.61146 -7847 4 9.79743 14.0525 33.3881 -28.4056 0.15536 2.16046 -7848 6 21.8963 10.8464 11.5207 26.0054 2.65771 10.2946 -7849 4 22.8204 10.615 11.7238 1.04479 5.32162 -7.74354 -7850 4 21.5123 10.8483 12.397 -14.7134 -4.5627 10.8449 -7851 6 38.3602 6.02493 25.8481 -1.65407 -6.16467 0.326828 -7852 4 38.011 6.16356 26.7557 4.19059 11.4538 -13.8011 -7853 4 38.4332 6.8537 25.3449 -2.0709 2.94932 12.5244 -7854 6 30.9335 26.6426 38.5759 12.2579 -6.52521 -50.146 -7855 4 30.9725 26.4832 39.4983 -1.12433 -12.3748 34.5417 -7856 4 31.1634 25.7976 38.1184 -10.2303 12.0451 18.6771 -7857 6 30.1758 14.6176 35.4883 -28.0954 45.5198 -22.6945 -7858 4 30.377 15.4621 34.9933 16.3957 -28.3235 8.82257 -7859 4 29.2055 14.6893 35.4544 11.1506 -16.8188 10.9927 -7860 6 12.5393 37.2199 16.9523 -39.8589 -5.36999 -7.27655 -7861 4 12.8749 37.9509 17.4338 22.3846 22.4284 20.6781 -7862 4 13.1653 36.5135 16.9845 23.2041 -13.3789 -0.375674 -7863 6 27.4265 21.5607 37.7225 20.8747 -12.9562 -0.181201 -7864 4 26.9326 21.725 36.9211 -12.0211 3.79264 -7.84561 -7865 4 27.0206 21.994 38.4656 -12.5008 8.35973 2.85409 -7866 6 29.6119 18.3909 12.6766 5.02953 -16.5769 27.1188 -7867 4 29.5217 18.1084 13.6179 -1.01954 6.11509 -19.9302 -7868 4 28.7057 18.4542 12.3734 -9.03627 4.70036 -1.08008 -7869 6 2.35849 15.6559 0.172343 -13.1317 26.5324 40.4931 -7870 4 1.57628 15.538 41.5798 -33.9312 2.46749 -10.4392 -7871 4 2.94928 15.1153 41.6306 46.9044 -35.3027 -23.6199 -7872 6 17.8239 25.728 4.21905 -37.6117 -8.49993 -31.7596 -7873 4 16.8718 25.6243 3.8952 33.4499 1.9374 22.526 -7874 4 18.2969 25.7387 3.3671 7.88894 5.9968 18.5236 -7875 6 41.8048 11.1855 20.2736 -2.74436 -4.31591 -6.39865 -7876 4 42.499 11.3266 19.6063 -2.31748 -7.213 6.47037 -7877 4 40.9812 11.3277 19.7997 -4.16553 7.78699 0.129723 -7878 6 38.0436 18.3822 24.0291 -8.03771 -8.75406 0.916934 -7879 4 38.3881 19.1147 24.5363 7.93091 8.32946 7.65245 -7880 4 37.8775 18.7197 23.1534 1.15748 3.59885 -9.88254 -7881 6 4.13949 13.9245 33.751 32.8429 -54.5446 -5.73928 -7882 4 3.27676 13.674 34.0388 -19.3763 3.63281 4.9893 -7883 4 4.61955 13.0097 33.6871 -20.752 50.0513 -2.76975 -7884 6 19.1955 19.1942 26.4999 -2.68794 -13.6734 16.0889 -7885 4 19.5301 20.0447 26.2113 2.49975 9.05121 -5.4902 -7886 4 18.8802 18.7176 25.7363 0.91839 -0.338605 -10.966 -7887 6 22.4654 26.212 25.3377 -43.9819 -31.3945 15.8492 -7888 4 22.341 25.462 24.7348 6.987 2.92742 -4.90062 -7889 4 23.2684 26.6111 25.1223 47.0594 15.091 -19.0516 -7890 6 48.8212 32.07 32.5598 -32.6217 13.0764 9.49579 -7891 4 48.8519 31.1339 32.3903 9.77015 -16.5586 -2.94571 -7892 4 49.6142 32.4858 32.2593 19.8009 3.1546 -7.06015 -7893 6 25.2092 18.0177 27.0119 4.84672 -18.7822 -3.15467 -7894 4 24.5216 17.4674 27.4199 2.41306 12.0417 3.55819 -7895 4 25.6695 17.4202 26.3966 -2.25094 9.61905 1.21472 -7896 6 1.75029 41.5558 24.9373 10.8929 -9.66126 -16.5331 -7897 4 1.94143 40.8029 24.3062 -11.1729 27.8661 22.017 -7898 4 1.33214 0.330238 24.3814 7.15774 -16.2959 10.6574 -7899 6 18.6827 11.7655 10.8523 -12.8723 -21.6642 16.1997 -7900 4 19.5636 11.9042 10.4948 -5.12175 -0.337419 -4.96303 -7901 4 18.6779 10.8452 11.2231 -2.76434 23.9208 -10.2934 -7902 6 45.6216 16.5622 4.85345 35.2391 7.72621 -8.96994 -7903 4 46.5826 16.2921 4.84248 -29.2944 1.01327 2.32041 -7904 4 45.6571 17.5026 4.56372 -8.00263 -16.2723 6.75488 -7905 6 40.6693 36.3938 24.0175 15.8353 8.34465 -33.37 -7906 4 40.8833 36.7626 23.1096 -14.2319 -6.57786 31.0793 -7907 4 40.765 35.4388 23.9669 -2.25062 -4.28397 3.06966 -7908 6 32.2103 36.323 4.961 11.3673 -15.0032 -27.5021 -7909 4 31.6022 36.0041 4.27996 -13.8963 14.3234 5.17466 -7910 4 32.9864 35.7931 4.73143 4.05858 7.46319 17.1387 -7911 6 1.60869 14.6755 10.8061 -10.0389 6.06769 39.8197 -7912 4 2.33356 15.3221 10.9109 -7.21973 -7.23845 -0.707439 -7913 4 1.19104 14.6475 11.7231 10.7485 2.93157 -30.114 -7914 6 35.0001 14.2727 28.079 63.2852 10.3217 34.449 -7915 4 34.8812 14.1453 29.0533 -4.19424 -2.10072 -23.3494 -7916 4 34.1798 14.2655 27.6589 -51.5469 -5.32036 -14.2309 -7917 6 54.7125 6.11605 21.8555 -14.0361 -8.25377 2.86163 -7918 4 53.7845 6.02557 22.1597 12.8111 1.82594 -4.22103 -7919 4 0.03027 6.89073 22.319 4.64766 10.0402 5.34703 -7920 6 31.7713 16.925 27.3783 -6.86907 -7.88471 17.2493 -7921 4 30.8352 17.1376 27.29 -7.38275 1.84485 -8.02972 -7922 4 32.1916 17.1776 26.567 8.49209 11.7792 -21.4891 -7923 6 14.465 28.0197 11.093 -4.59026 -39.5121 13.6529 -7924 4 14.1257 28.8224 11.4501 -8.46011 24.0779 0.0563038 -7925 4 14.7692 28.1802 10.1981 4.52198 5.50754 -5.24146 -7926 6 35.6475 19.4845 18.3155 9.57103 -1.809 -3.39748 -7927 4 36.1727 19.3545 19.1113 -4.74674 6.51425 2.74698 -7928 4 35.0476 18.7267 18.3208 -0.78661 10.9943 -3.1182 -7929 6 0.909574 12.7326 15.4512 -4.00403 -44.3255 -0.361194 -7930 4 0.713888 11.7498 15.2844 2.79491 38.2978 9.54583 -7931 4 1.42535 12.7402 16.2831 -6.10996 -1.10113 -5.97882 -7932 6 52.7151 14.8297 20.9852 -8.18072 -78.4028 12.8764 -7933 4 52.2089 13.9625 20.7908 19.9141 35.1606 18.4317 -7934 4 52.3599 15.4219 20.3591 -8.09633 28.1752 -16.3986 -7935 6 7.5074 6.79303 13.6094 20.1749 -33.1825 -2.20484 -7936 4 7.51894 7.72815 13.8132 13.5555 7.5777 -3.02343 -7937 4 8.44355 6.42469 13.5879 -32.5694 21.0012 0.325521 -7938 6 12.8707 29.146 30.9458 -23.5578 15.3335 -40.981 -7939 4 12.9428 28.445 30.3111 -4.06483 -0.044806 -18.3112 -7940 4 13.2276 28.7127 31.6654 25.7046 -17.9249 62.7325 -7941 6 8.91318 29.991 35.6703 -0.0610651 3.14803 31.5119 -7942 4 8.887 30.0597 36.6571 13.1627 -14.4278 -23.4692 -7943 4 8.81345 30.9051 35.4106 0.983205 7.41015 -17.1111 -7944 6 29.2436 7.20633 5.57892 -54.0378 33.243 -15.4453 -7945 4 29.9077 6.6209 5.82325 37.3203 -38.0996 12.3519 -7946 4 28.4255 6.92245 6.05186 24.5111 10.6259 -6.90283 -7947 6 25.8948 9.2579 3.86177 -16.7921 -19.1399 -16.9328 -7948 4 26.6486 8.78935 3.46547 3.6066 2.83982 9.7025 -7949 4 25.146 8.75694 3.47524 9.6908 8.1243 10.3781 -7950 6 46.1591 19.5353 23.8511 81.1089 -3.44953 5.31324 -7951 4 47.0572 19.4192 24.3423 -46.5837 0.334518 -9.80273 -7952 4 46.5432 19.8542 23.0066 -21.4105 0.836057 1.37554 -7953 6 18.5926 35.3225 28.784 52.2521 -24.0621 1.05868 -7954 4 18.6271 36.1437 28.292 -9.91963 10.3291 -8.20284 -7955 4 19.5499 34.9756 28.7398 -42.866 14.0686 4.10052 -7956 6 27.9863 22.6413 32.202 21.6529 -11.7193 -18.2399 -7957 4 28.0891 22.9783 31.3009 1.03266 3.02954 6.56078 -7958 4 27.1414 22.9613 32.5068 -4.28354 -0.549074 4.96673 -7959 6 25.9903 18.4326 22.6797 -22.9747 -15.6034 11.3844 -7960 4 26.7869 18.8273 22.3692 24.9379 13.7229 -5.91644 -7961 4 25.7208 18.921 23.4832 11.724 -6.94511 -8.75168 -7962 6 31.1697 23.092 29.1693 -11.9745 -15.1316 21.2053 -7963 4 31.2077 22.141 28.9533 -3.34012 7.58841 -3.35467 -7964 4 31.7416 23.575 28.5808 9.8436 3.86516 -11.5721 -7965 6 36.6303 4.93142 0.48008 48.3 12.3871 -22.3067 -7966 4 36.6637 5.82298 0.895967 -3.77214 -15.5899 -6.86281 -7967 4 37.4556 4.91994 41.7793 -42.6939 0.501904 23.801 -7968 6 36.4828 20.995 10.0445 1.4409 16.9025 7.88029 -7969 4 36.442 20.1354 9.60774 -3.67605 2.90774 1.0232 -7970 4 35.8889 20.9899 10.8082 0.675338 -5.55749 -3.21659 -7971 6 50.6068 25.1826 18.3885 -34.0155 8.99756 4.28297 -7972 4 49.9165 24.7513 17.8483 3.12051 4.84127 10.9758 -7973 4 51.4426 24.9479 18.0312 23.0155 -7.64449 -5.94589 -7974 6 50.1857 39.6546 12.4249 -35.8487 -4.75972 18.1961 -7975 4 49.7435 38.8097 12.6589 9.38526 12.3917 -5.89531 -7976 4 51.0761 39.4561 12.2056 25.3285 -5.23538 -8.69122 -7977 6 30.5392 12.4112 4.81308 -24.6918 -8.37115 23.8709 -7978 4 30.0105 11.5821 4.90198 12.5687 16.0288 7.14 -7979 4 30.9611 12.2897 3.99028 20.9425 -4.88336 -30.4106 -7980 6 28.9507 15.4785 21.8764 2.88494 -37.77 16.9414 -7981 4 29.2026 14.5932 22.3105 -13.0637 39.016 -13.1967 -7982 4 28.2142 15.8194 22.4189 7.40001 -5.36107 -10.8423 -7983 6 14.0621 9.56364 16.9937 6.86557 -12.9325 3.68967 -7984 4 14.7638 8.91135 17.1437 -0.397896 3.39204 -3.97785 -7985 4 14.5001 10.412 17.0773 -1.84745 7.98018 -3.95086 -7986 6 4.48418 30.1793 11.8502 16.4679 -16.8356 33.0547 -7987 4 4.88144 29.8061 12.6848 -7.18701 8.62616 -23.9784 -7988 4 3.54784 30.2411 12.0492 -7.30801 4.11375 -9.31782 -7989 6 40.8925 8.06286 23.6531 -5.33465 -0.617655 -7.49645 -7990 4 40.8929 8.28602 22.6923 5.67883 -10.477 13.1878 -7991 4 40.7177 7.10184 23.7416 4.86142 9.55736 -10.8624 -7992 6 53.7474 35.0502 16.7091 9.64852 13.8526 -34.5004 -7993 4 53.4511 35.8404 17.1588 -1.68768 2.98716 11.3576 -7994 4 54.0332 35.3898 15.821 -5.01984 -16.258 24.672 -7995 6 53.7089 10.1864 20.3635 2.29909 -3.91508 11.8946 -7996 4 53.865 9.95358 19.435 -6.30341 10.2468 0.803923 -7997 4 53.074 10.9174 20.4153 4.1525 1.61451 -13.3956 -7998 6 4.58325 27.0727 7.79253 38.2121 26.3993 -10.0836 -7999 4 5.27724 26.393 7.80253 -10.2172 -9.80276 1.23658 -8000 4 3.71677 26.7514 7.92113 -24.69 -25.9094 6.50141 -8001 6 50.5074 22.5408 22.1421 -8.69376 -16.3879 19.9073 -8002 4 50.2488 23.2402 22.7623 5.11604 2.17524 -13.9015 -8003 4 50.7961 22.8564 21.2903 3.5618 14.8025 -7.32432 -8004 6 7.04732 27.2027 21.6256 -40.8926 -21.8944 23.9514 -8005 4 6.7035 26.7027 22.422 28.3929 12.8045 -18.4773 -8006 4 6.19014 27.4064 21.2095 22.0893 5.82121 -6.88916 -8007 6 23.8331 35.0488 16.5891 16.32 14.4309 46.4508 -8008 4 24.6955 34.7392 16.9507 -15.4311 10.68 -10.0146 -8009 4 23.6772 34.608 15.7848 -0.180345 -20.5093 -35.2233 -8010 6 5.99568 23.9111 3.91414 -16.1284 -13.3557 2.33299 -8011 4 5.47632 24.0272 3.08057 3.14343 -7.41418 20.837 -8012 4 5.41258 23.5631 4.6401 5.53308 9.77645 -18.8553 -8013 6 38.7285 25.0725 19.1284 6.5843 12.292 11.4002 -8014 4 38.8305 24.3279 18.5317 -0.433768 -14.0645 -4.65001 -8015 4 38.9527 24.8378 20.0476 4.74577 -1.1864 -10.184 -8016 6 12.9754 18.2903 10.6176 0.588158 -4.74371 -11.7219 -8017 4 12.1189 18.2831 10.1754 -4.50324 1.27903 -1.36841 -8018 4 12.8026 18.5801 11.5112 2.24696 5.46905 14.7352 -8019 6 38.0467 41.2366 21.1082 -14.4892 -16.6352 -5.66336 -8020 4 37.1721 40.8226 21.1941 10.2151 -2.13153 3.70269 -8021 4 37.8745 0.133442 20.6393 0.730193 23.6843 -6.95691 -8022 6 6.9767 22.8602 17.8447 -15.6268 -18.8158 0.81989 -8023 4 7.5707 23.5707 17.6602 21.732 18.7089 -7.75629 -8024 4 7.31556 22.0497 17.428 2.05587 4.83625 4.35773 -8025 6 24.1095 19.3932 12.3316 12.1602 -2.11517 -13.1018 -8026 4 23.8745 19.734 13.1953 2.64822 12.0925 0.881714 -8027 4 23.8476 18.4865 12.3899 -10.6841 -23.2361 -5.46211 -8028 6 44.2232 28.4408 4.82746 -1.7669 2.66578 -25.5607 -8029 4 44.2803 28.1144 3.91045 1.22274 -3.80694 10.7546 -8030 4 44.1446 29.3994 4.68927 4.81937 -0.158515 8.55 -8031 6 23.3113 8.29915 21.4219 -9.51684 27.1403 7.66167 -8032 4 22.936 9.22921 21.4746 15.7805 -27.4461 5.90598 -8033 4 23.1012 8.0569 20.5135 3.89809 -6.65443 -0.402871 -8034 6 14.3464 2.18773 18.5362 -23.516 16.4481 4.67993 -8035 4 14.2678 1.24418 18.6898 10.1474 -10.2606 4.48578 -8036 4 15.2445 2.40605 18.3047 18.9771 -8.71598 -6.68368 -8037 6 28.0424 31.9381 34.1184 1.44373 -10.4149 10.0158 -8038 4 28.467 32.321 34.8914 3.92062 5.65333 3.09761 -8039 4 27.2701 32.5111 33.9835 5.51879 -6.95928 -12.9635 -8040 6 53.345 24.6925 18.2818 -10.4918 -25.9433 -31.7967 -8041 4 53.4866 24.6975 17.3285 -0.882305 -10.6531 -2.1422 -8042 4 53.7306 25.5021 18.5264 15.118 39.739 24.3772 -8043 6 36.8049 28.4285 22.9464 16.1639 5.31016 -1.79263 -8044 4 36.683 28.9472 23.7552 -13.3671 -7.69746 -0.238436 -8045 4 36.1639 27.7179 22.9267 -11.0056 -9.60672 10.1241 -8046 6 21.894 30.586 27.4834 -30.837 -7.47848 12.2714 -8047 4 22.1658 31.0121 28.3029 9.93408 7.2142 -4.82479 -8048 4 22.5499 30.6966 26.8178 23.3081 1.01511 -13.2982 -8049 6 10.2866 3.2829 27.2371 9.19947 -3.548 -7.92128 -8050 4 10.1566 2.73648 28.0281 -11.5907 7.20828 -5.58516 -8051 4 9.50383 3.79492 26.9844 -8.05462 -4.00143 11.7964 -8052 6 37.7145 25.01 29.7057 15.6828 -51.4836 -24.4954 -8053 4 38.34 24.5625 29.0621 -16.831 21.3675 19.2093 -8054 4 37.2613 24.2159 30.07 -2.41186 22.6264 5.87672 -8055 6 9.13271 24.4444 14.4751 26.0421 8.18538 46.692 -8056 4 9.10912 24.9781 13.7161 -5.31341 21.9098 -32.4591 -8057 4 8.68548 23.6494 14.2981 -19.3974 -37.2941 -14.6224 -8058 6 52.771 31.4727 7.38558 20.6973 -2.13415 1.08713 -8059 4 52.3061 32.183 6.93204 -2.34942 2.78723 -4.55897 -8060 4 52.1263 30.9997 7.89938 -16.8139 -9.70652 3.3966 -8061 6 21.3286 5.45224 36.4983 22.333 -40.4406 3.83692 -8062 4 20.7026 5.40277 37.2139 -7.55906 11.9598 8.05023 -8063 4 21.8475 4.61683 36.6516 -9.65069 29.8227 -15.0031 -8064 6 25.1743 37.2092 4.31919 7.23092 6.80805 -6.24923 -8065 4 25.4754 36.7175 3.5165 -8.68629 0.834167 19.7743 -8066 4 24.8491 36.6197 5.01948 2.53349 -5.19005 -7.77823 -8067 6 34.0165 17.4759 18.2358 -58.4306 -31.0723 45.6386 -8068 4 34.1944 16.9598 19.0779 8.50138 15.1756 -22.5601 -8069 4 33.0528 17.7413 18.4058 39.5305 3.9888 -12.396 -8070 6 37.9578 37.5059 25.2944 -35.6234 -15.4362 -10.7836 -8071 4 36.9622 37.6721 25.197 38.0574 -5.35834 -1.14338 -8072 4 38.1643 36.7565 24.689 -7.79603 13.8086 8.25116 -8073 6 5.07735 4.86484 15.8417 42.9381 3.72816 7.10952 -8074 4 5.88838 4.293 15.9163 -33.8081 0.492332 -6.16483 -8075 4 5.50277 5.71956 15.9997 -16.006 -0.473971 1.61617 -8076 6 14.1507 7.19336 7.76886 38.052 -10.4208 -22.4486 -8077 4 13.5129 7.55624 8.34295 -29.9694 15.266 25.1048 -8078 4 13.7195 6.96448 6.9333 -0.98027 3.69224 9.82406 -8079 6 24.98 10.8641 38.0829 22.9212 14.7137 56.6455 -8080 4 25.3157 11.7906 38.09 -5.76353 -21.6486 -14.5596 -8081 4 24.5861 10.6473 37.2742 -21.4949 -6.61803 -48.2716 -8082 6 35.683 7.97762 22.8121 -8.7657 -2.24292 -6.28447 -8083 4 36.2591 8.71308 23.0369 7.49089 3.45465 4.10549 -8084 4 35.4159 8.13228 21.894 -1.16553 2.61323 2.89561 -8085 6 24.8067 29.1485 22.4175 -2.13284 -11.1741 5.39142 -8086 4 24.8847 28.3567 22.9764 5.78872 7.02228 0.265808 -8087 4 23.868 29.1687 22.2304 -8.38579 3.51829 -7.32943 -8088 6 38.496 31.6463 38.4547 5.18571 -7.52333 -11.192 -8089 4 38.5561 32.3892 37.8222 0.442926 -5.96945 11.3455 -8090 4 38.4779 31.9675 39.3579 -6.04594 15.0172 8.52038 -8091 6 7.23911 33.2316 15.4021 21.919 9.41665 12.382 -8092 4 8.12833 33.2899 15.8377 -30.0201 5.59214 -9.80336 -8093 4 7.41373 32.5516 14.7298 -12.8129 5.82399 11.4308 -8094 6 43.353 23.6104 1.44592 7.44142 11.305 12.851 -8095 4 43.1845 24.4377 0.974361 -3.6145 -11.1369 -5.61195 -8096 4 44.1543 23.8467 1.95013 -11.1925 -12.9992 -13.6036 -8097 6 3.53991 32.9016 14.8697 -2.39625 2.76445 6.29056 -8098 4 3.69073 33.2429 13.9877 -3.53656 0.018747 -12.9915 -8099 4 3.78624 33.6349 15.4383 2.83762 5.11564 5.16825 -8100 6 25.3096 21.77 8.26163 -6.66296 0.990367 -4.9072 -8101 4 26.025 21.1206 8.24337 -4.14835 5.1806 10.2199 -8102 4 24.7855 21.68 9.08833 13.2195 -2.77387 -11.0894 -8103 6 43.8224 15.3683 17.7688 -17.5044 -13.9077 -11.4765 -8104 4 43.5422 15.0425 16.8907 -4.65964 7.2866 4.53357 -8105 4 44.7684 15.2434 17.7192 12.2011 1.97977 1.51727 -8106 6 15.7838 16.2525 16.6573 54.0838 12.7989 52.3812 -8107 4 16.4697 16.8261 16.2793 -6.54184 -0.771336 -3.5329 -8108 4 15.1467 16.1661 16.0105 -48.6612 -2.23154 -48.9531 -8109 6 31.9022 12.8519 11.5241 2.75902 49.2592 5.12049 -8110 4 32.4395 13.2725 12.2474 -7.6131 -20.2803 -12.0836 -8111 4 31.5562 13.6461 11.0457 0.0384164 -26.7823 6.27126 -8112 6 18.2248 5.33623 10.1812 -15.488 18.8418 -23.6702 -8113 4 17.7687 5.75894 9.42369 15.7694 -11.8332 4.62439 -8114 4 17.5271 5.29555 10.8288 -1.36455 -9.23689 12.3446 -8115 6 23.0917 39.0779 10.9282 -11.4905 7.21092 -0.352408 -8116 4 23.963 38.6888 10.8472 1.7552 7.95734 1.65941 -8117 4 23.1114 39.9529 10.5005 0.666922 -10.0515 1.633 -8118 6 46.8677 33.7562 8.76248 1.03354 -2.05441 8.38343 -8119 4 46.5037 34.5328 8.27588 2.5022 -8.853 20.9954 -8120 4 47.1475 33.9422 9.6931 -6.44786 13.1686 -22.3696 -8121 6 31.243 39.9317 20.2224 2.33635 -7.70313 -8.05101 -8122 4 30.8704 39.2996 19.5871 0.699046 7.37293 6.91414 -8123 4 32.2017 39.8574 20.0757 -3.27099 6.09826 0.0696837 -8124 6 15.889 33.0919 19.7864 33.8788 -7.40125 -13.3883 -8125 4 16.1628 33.8221 19.1895 -10.4151 -15.5823 0.760964 -8126 4 16.5176 32.3427 19.5839 -16.9866 18.4919 10.6578 -8127 6 32.5555 39.9164 2.66523 30.0039 -10.6491 -2.95451 -8128 4 33.3508 39.5896 3.12591 -10.8726 3.49711 -8.16538 -8129 4 32.1027 40.3655 3.36837 -16.5932 8.39248 6.84073 -8130 6 50.6959 12.1983 3.90519 17.0412 -18.9771 -24.2847 -8131 4 51.4658 12.4814 3.40053 -2.43524 -2.94964 -4.56419 -8132 4 50.632 12.8314 4.58319 -9.04718 30.5099 32.8795 -8133 6 44.7022 2.76366 12.1205 -8.84849 12.6495 8.41904 -8134 4 44.8494 1.8734 11.8267 15.0216 -15.1797 -4.64519 -8135 4 44.7278 2.73137 13.1008 3.87902 2.35132 -20.2006 -8136 6 11.5141 11.9335 31.6448 -3.41939 3.48047 19.9552 -8137 4 11.2577 12.7405 32.1375 2.53248 -5.05318 0.0588515 -8138 4 11.4496 11.2091 32.2982 6.40928 8.91696 -7.15415 -8139 6 4.75269 10.0418 10.4949 -1.19321 15.9867 3.21309 -8140 4 5.0001 10.2283 11.4058 3.15466 -0.54389 -0.234941 -8141 4 4.46559 10.9018 10.1184 3.18705 -14.0527 1.96128 -8142 6 17.0994 25.0099 20.58 37.5195 36.994 -31.4742 -8143 4 16.2483 24.8536 20.9144 -42.3557 -15.7488 8.6923 -8144 4 16.9647 25.6792 19.8535 4.26961 -24.361 15.5384 -8145 6 48.1092 4.75471 14.8037 19.9531 12.9172 -19.4869 -8146 4 47.21 5.0173 14.8371 -33.3483 -4.43172 15.4156 -8147 4 48.388 5.38041 14.11 12.4129 -13.382 8.75366 -8148 6 18.8523 3.11742 3.41631 -21.2483 -3.07087 -4.7476 -8149 4 18.4665 2.24821 3.59937 1.50537 0.955968 2.27262 -8150 4 19.7704 2.98892 3.60058 26.8928 -3.50499 2.30699 -8151 6 35.4247 26.4577 29.0527 -22.8013 -8.66021 5.68805 -8152 4 35.5248 27.2067 28.475 -2.85698 13.778 -9.76065 -8153 4 36.2768 26.0489 29.0602 21.3259 -10.4415 3.203 -8154 6 32.3896 31.2185 12.8503 57.1958 12.7231 -6.23232 -8155 4 31.5925 31.2509 13.3022 -48.7441 2.01486 27.8379 -8156 4 32.2029 30.8426 12.0127 -5.8383 -14.614 -31.3947 -8157 6 33.0076 28.3366 37.5983 -27.3824 -5.67666 30.0102 -8158 4 32.1052 27.9852 37.8568 28.4022 2.55731 -9.07316 -8159 4 33.3988 28.5694 38.4733 -3.969 -4.9759 -22.0899 -8160 6 45.5072 24.7908 10.3169 -45.8214 60.3209 -7.47747 -8161 4 44.9002 25.317 9.70444 28.5781 -13.9385 29.3176 -8162 4 45.5876 23.9971 9.85482 14.9117 -49.3191 -19.3714 -8163 6 14.779 31.7044 3.16918 -45.5594 -6.97168 29.5477 -8164 4 14.0337 32.2859 2.90387 21.9125 -3.3602 -3.07131 -8165 4 14.4311 31.26 3.996 20.2164 14.1486 -26.6391 -8166 6 31.9242 7.68885 4.30286 23.54 -20.9123 31.4536 -8167 4 31.4705 6.84633 4.17995 2.0164 -2.82895 4.59018 -8168 4 31.5931 8.24323 3.64247 -18.259 33.7262 -37.7068 -8169 6 42.5699 17.3136 32.1968 24.1944 7.3606 3.32713 -8170 4 41.6254 17.2329 32.2603 -19.9776 4.79877 -7.53323 -8171 4 42.7917 18.2007 31.8224 -10.4585 -19.5065 0.0265862 -8172 6 13.8071 23.1746 23.5515 16.4347 -15.6283 -2.15259 -8173 4 13.5183 23.7639 24.245 0.233797 9.11225 10.6616 -8174 4 14.6093 22.7029 23.9066 -20.7684 16.5326 -5.05411 -8175 6 10.7126 7.09833 3.97095 14.1471 -33.6721 -68.9477 -8176 4 10.4245 6.93934 4.82914 -14.4566 -0.97954 55.1879 -8177 4 10.4869 6.2311 3.50145 10.3151 35.4271 10.8748 -8178 6 28.7967 8.6797 17.9015 -30.1103 -2.72244 -33.0478 -8179 4 29.5795 8.35746 17.4579 9.90558 -6.78874 -8.85398 -8180 4 28.1705 8.90161 17.1378 19.1156 -3.64084 26.8114 -8181 6 19.4515 29.3423 26.6295 -39.4767 12.5835 42.7579 -8182 4 19.0038 29.6555 27.482 17.5864 -10.0531 -35.2193 -8183 4 20.2946 29.7741 26.6551 17.8114 4.03003 1.9258 -8184 6 40.6571 40.9865 14.5722 30.7749 0.116883 17.4953 -8185 4 40.9453 41.7159 14.038 -4.90719 13.3855 -18.4876 -8186 4 41.4974 40.7167 14.9881 -11.2006 -4.47055 2.16552 -8187 6 46.2595 14.0857 31.7293 11.6035 -9.35965 4.24636 -8188 4 46.4659 13.1386 31.6985 -1.25294 5.8657 1.71226 -8189 4 45.5092 14.1916 31.1613 -13.5258 4.10617 -10.238 -8190 6 36.7111 36.3198 8.38634 20.5175 24.5507 44.7988 -8191 4 36.5848 37.248 8.66174 -25.6048 -20.3538 -28.8485 -8192 4 37.4262 36.1922 9.03978 -4.76011 -28.7723 -18.9481 -8193 6 30.7791 32.4382 38.0814 8.60258 1.74334 21.9396 -8194 4 31.3949 31.9394 37.5795 9.21482 -20.9838 -26.5205 -8195 4 31.4122 32.9586 38.5821 -11.3785 16.1645 3.6603 -8196 6 47.8794 8.8384 10.1746 26.299 41.1069 27.7005 -8197 4 47.2075 9.11907 9.56312 -13.0744 -2.84885 -16.672 -8198 4 48.1152 7.93695 10.1106 -1.40956 -33.8723 -12.987 -8199 6 24.4191 17.0005 30.9872 -11.3759 2.04439 -13.9008 -8200 4 23.6647 16.9339 30.3566 16.9629 0.0568796 9.7226 -8201 4 24.0218 17.1528 31.8579 2.94571 -1.21426 -7.57694 -8202 6 40.5018 5.09847 4.47991 -26.6992 -20.3188 -5.14046 -8203 4 41.28 5.65048 4.47318 14.3705 11.228 -11.5737 -8204 4 40.0798 5.05838 3.58104 19.0568 4.03597 15.916 -8205 6 52.5742 28.0973 6.9077 -25.4379 -29.0344 16.6943 -8206 4 52.3933 28.6001 6.11132 1.2128 1.19853 -1.81518 -8207 4 51.7383 27.5823 7.10916 28.4347 22.908 -9.38917 -8208 6 36.064 32.3866 23.6124 7.53581 -25.1682 -6.10704 -8209 4 36.4508 32.2046 22.7426 1.48893 5.77393 9.47334 -8210 4 35.7934 33.2936 23.5958 -9.41601 17.7382 0.925908 -8211 6 23.6488 31.8764 22.7665 2.85736 4.06253 -9.33391 -8212 4 23.7634 32.5358 22.0878 -9.04528 15.3932 -0.43099 -8213 4 24.3599 31.3007 22.5126 8.23075 -21.5035 13.0322 -8214 6 0.735457 24.4657 41.7131 -9.37188 -1.3071 -20.2528 -8215 4 1.20497 24.8068 40.9273 -3.735 -3.01915 11.177 -8216 4 54.8235 24.2347 41.4089 15.688 5.53844 3.35783 -8217 6 15.9771 8.98022 19.8191 22.6241 -28.8974 20.594 -8218 4 15.5109 8.26292 19.4118 -7.13343 -10.7615 -13.7959 -8219 4 15.6388 9.77471 19.4696 -19.2292 39.8019 -15.8774 -8220 6 33.1716 12.5629 20.0326 13.9441 -12.6476 -4.49459 -8221 4 32.9044 11.6183 19.8429 16.5289 30.3248 6.35834 -8222 4 34.162 12.7185 19.975 -34.5589 -12.2038 -12.3621 -8223 6 7.03971 24.945 26.3683 -0.33354 -9.69316 23.9049 -8224 4 6.80945 24.3756 27.1101 -9.22275 -9.46444 -2.85995 -8225 4 7.84656 25.3251 26.6963 17.391 9.90995 -3.06061 -8226 6 44.4739 22.5508 36.9255 -16.7075 -6.88118 10.4755 -8227 4 43.5027 22.4108 36.9334 15.1456 1.07948 9.67769 -8228 4 44.6732 22.7799 36.0336 3.04889 5.98288 -21.3947 -8229 6 39.2775 23.7142 25.1185 -44.4168 -97.0378 5.9092 -8230 4 39.6033 24.5307 24.937 33.9242 88.3913 -14.6991 -8231 4 38.7559 23.4597 24.3323 8.03463 3.9453 13.1815 -8232 6 20.3756 2.20712 36.9897 -7.56257 -5.27652 1.95266 -8233 4 20.2168 1.45659 37.5665 4.06747 -3.41627 8.94019 -8234 4 20.2802 1.85339 36.1124 5.28277 1.38 -10.8685 -8235 6 22.8571 19.5527 3.6659 6.2145 7.79245 45.4341 -8236 4 22.8782 19.7834 4.64919 -10.5004 -5.13291 -37.3231 -8237 4 23.7426 19.8021 3.38476 9.02488 -3.84737 -6.15569 -8238 6 31.6989 12.5719 34.5929 20.3571 12.3337 69.8717 -8239 4 31.0774 13.2339 35.0297 17.9304 -15.3013 -22.977 -8240 4 32.3378 12.3324 35.3667 -30.4994 7.85147 -45.3393 -8241 6 12.9846 10.2214 25.1019 -30.6317 10.0697 -32.3453 -8242 4 13.6677 9.95937 25.6652 38.8731 -4.05338 37.0168 -8243 4 12.5116 9.4018 25.0264 -11.673 -9.01961 -8.06086 -8244 6 27.2702 0.587979 13.2088 -29.2359 -8.68669 8.17042 -8245 4 27.7024 41.6312 13.2942 -2.56798 3.03598 -7.56301 -8246 4 26.2795 0.464606 13.259 26.6373 -0.778522 -5.81594 -8247 6 5.6575 24.9337 13.9905 13.1991 2.90197 -9.87868 -8248 4 4.70598 24.9553 13.883 -5.9976 0.782062 8.57209 -8249 4 5.90972 25.4072 14.7914 -9.20077 -1.59682 1.38283 -8250 6 22.9799 17.9518 0.527007 -12.0607 -30.0717 13.8125 -8251 4 22.428 18.6392 0.176667 -3.67819 14.6501 -9.17369 -8252 4 22.2816 17.3415 0.914453 31.709 16.1034 -10.9012 -8253 6 33.0985 25.4181 5.46205 -15.7978 -31.0624 1.20161 -8254 4 33.3789 26.3039 5.55078 15.9502 30.9866 -6.27287 -8255 4 32.9645 25.2082 4.52957 3.04969 3.7853 3.27689 -8256 6 8.52872 7.94688 17.4833 18.4257 15.9711 -24.7978 -8257 4 9.39098 8.3855 17.3119 -11.8135 -8.35054 -2.98105 -8258 4 8.4858 7.94817 18.4262 -6.55829 -2.0729 23.5191 -8259 6 26.8237 0.686378 2.88748 4.07 30.2002 2.01549 -8260 4 26.8412 0.391628 3.80568 -3.86709 0.733005 8.35451 -8261 4 26.5975 1.66265 2.91719 8.86873 -29.5911 -1.41132 -8262 6 50.0397 34.7157 15.6267 -11.8175 -1.09292 -1.87233 -8263 4 50.6372 35.2521 15.0721 -14.1207 -5.91477 -4.02646 -8264 4 49.1323 34.6374 15.219 24.748 6.82197 2.94942 -8265 6 46.275 5.00035 11.1282 9.7079 18.7279 -10.06 -8266 4 45.8191 4.20733 11.3912 -11.1099 -14.8598 8.88229 -8267 4 46.9633 4.71614 10.5231 1.70636 -6.51939 -1.67277 -8268 6 33.7833 38.63 35.3851 22.6491 -26.5736 53.3982 -8269 4 34.0604 38.9625 36.3013 -14.2885 -2.00103 -44.5517 -8270 4 33.6201 39.3455 34.786 -2.63152 22.0909 -4.2817 -8271 6 30.8201 25.8435 41.2101 0.522631 -30.718 -12.9218 -8272 4 31.0968 24.9266 41.4082 -1.05643 6.85883 -6.1679 -8273 4 31.1715 26.3436 0.016995 6.66556 20.3816 22.2796 -8274 6 50.2276 0.978128 24.4598 74.6558 22.0158 36.8282 -8275 4 49.5306 0.534407 24.0585 -38.5843 -30.8873 -31.929 -8276 4 51.1134 0.532188 24.3239 -37.6779 9.32343 -0.630533 -8277 6 31.2996 0.720873 19.0302 14.3507 40.5737 -10.6901 -8278 4 30.4605 0.743437 18.5837 -16.9464 -9.10756 -3.3833 -8279 4 31.3343 41.8987 19.5933 -6.31648 -47.867 22.0648 -8280 6 39.0778 29.5479 19.1423 -24.9794 -6.4558 -1.7207 -8281 4 38.1293 29.5816 19.4551 33.1986 -8.08964 -3.40762 -8282 4 39.446 28.6506 19.2986 -6.02354 14.8003 0.990496 -8283 6 21.659 17.5991 25.8953 -11.5386 33.2832 -7.33353 -8284 4 22.0418 18.5204 25.967 -8.02723 -30.5851 6.12101 -8285 4 20.778 17.7492 25.4824 18.7799 -9.30112 4.66445 -8286 6 35.0777 28.803 27.4254 -1.70316 -21.0069 37.4458 -8287 4 35.3301 29.4791 28.0775 3.3924 -2.39002 -8.5847 -8288 4 35.0935 29.2141 26.5843 6.79083 21.8236 -32.9604 -8289 6 30.7137 25.4449 11.6588 -11.4017 25.922 39.321 -8290 4 30.5753 25.9017 12.5616 8.60864 -26.5127 -36.0552 -8291 4 30.5331 26.1452 11.022 4.69716 -0.666916 0.479504 -8292 6 7.33812 15.1344 12.3538 4.68116 -40.544 31.6975 -8293 4 6.75693 14.3594 12.209 2.06777 16.361 -3.14284 -8294 4 7.31295 15.622 11.5607 -9.0052 27.071 -31.8075 -8295 6 16.8334 26.8188 7.04972 -25.5936 3.66279 -30.8653 -8296 4 17.5758 26.708 7.59816 38.4339 -11.2263 23.8467 -8297 4 17.1819 26.9966 6.1597 -5.58153 -2.73835 6.66814 -8298 6 29.5302 33.0784 31.0001 -37.3865 -15.0005 -19.6245 -8299 4 28.6433 32.7554 30.7459 2.04647 15.9344 -4.27919 -8300 4 29.8764 32.2746 31.3613 18.5632 -10.7791 20.7082 -8301 6 14.1048 2.11879 30.9099 -3.69766 -14.7615 43.6071 -8302 4 14.1458 1.95878 31.9138 -8.46722 9.63961 -39.7078 -8303 4 13.6642 1.31591 30.5661 9.09938 8.95306 -0.112961 -8304 6 15.6571 22.2632 2.89617 -37.5764 43.5932 -9.62192 -8305 4 16.4348 21.7941 3.05118 39.5293 -34.0009 4.7875 -8306 4 15.0286 21.6897 2.4522 -3.10464 -12.538 6.06705 -8307 6 23.7259 29.1153 40.9645 17.3396 38.8389 1.6287 -8308 4 23.2818 30.0193 40.9831 11.4767 -32.1544 -0.906545 -8309 4 24.7087 29.2887 40.9216 -25.4222 -7.32646 2.20707 -8310 6 38.1247 14.1642 13.7107 12.8592 31.0763 6.54808 -8311 4 37.6278 13.3808 13.8383 -17.8092 -31.0521 2.1891 -8312 4 38.9029 13.9224 13.2095 7.41852 -3.42228 -8.90759 -8313 6 35.2503 26.5068 15.521 -3.09354 13.3371 19.8917 -8314 4 34.5349 26.5126 14.8818 -0.932758 -4.81772 -4.34805 -8315 4 34.9075 27.0382 16.2823 10.0491 -13.0104 -19.4153 -8316 6 19.0968 34.7379 16.486 5.71756 23.995 22.7437 -8317 4 19.4075 35.6523 16.3704 4.72819 -11.1284 17.3551 -8318 4 19.0401 34.4508 15.6072 -6.41662 -20.6903 -39.0731 -8319 6 18.1723 29.7514 35.7083 20.6671 12.6318 -10.71 -8320 4 18.3041 30.5743 35.1773 -7.60682 -14.8418 20.474 -8321 4 19.0351 29.5718 36.145 -10.3356 2.9076 -6.19235 -8322 6 54.1213 22.2675 24.9131 12.7342 -33.1199 -26.8219 -8323 4 53.6265 21.7967 24.1967 9.15099 10.4438 12.7736 -8324 4 53.5183 22.8995 25.2476 -23.1208 24.5105 7.38222 -8325 6 30.3446 10.3415 34.0026 7.84994 -0.761596 -9.91104 -8326 4 29.5868 10.4349 34.5739 -14.9697 1.07498 11.7851 -8327 4 30.8511 11.1643 34.0933 -4.52293 -3.62201 3.70872 -8328 6 38.3178 33.8965 18.5989 -35.8058 -11.4104 -3.76591 -8329 4 38.923 33.166 18.7063 19.7544 -4.29321 9.06839 -8330 4 38.8137 34.6503 18.3352 23.7539 21.4454 3.52643 -8331 6 22.4873 14.1653 34.4312 -21.9658 -17.0918 -49.1801 -8332 4 22.5571 13.4626 33.7145 -4.81718 29.7264 22.473 -8333 4 23.0772 13.8965 35.1058 26.7449 -1.29975 22.8703 -8334 6 38.021 0.617904 2.36461 -2.26574 -7.91048 -40.4777 -8335 4 37.6239 1.19646 3.0125 3.99393 1.59858 23.4614 -8336 4 38.7851 0.132723 2.71367 -6.22024 4.30596 13.4956 -8337 6 38.885 41.133 10.292 38.4397 69.693 -20.9517 -8338 4 38.7327 0.223589 10.3334 0.502898 -40.1285 -2.38265 -8339 4 38.1678 40.7662 10.7395 -40.074 -22.1176 34.0334 -8340 6 53.417 21.9266 38.962 18.4876 1.53578 17.2983 -8341 4 52.9974 21.8755 38.1026 3.71535 5.74942 -10.4205 -8342 4 54.37 22.1639 38.7939 -25.8904 -11.793 -3.59034 -8343 6 39.9933 12.7125 36.2959 -18.8272 27.1562 12.2819 -8344 4 39.0734 12.4542 36.2547 -7.90274 -1.75871 9.35878 -8345 4 40.3901 12.0873 35.7283 26.8007 -18.4843 -23.2317 -8346 6 48.44 17.2431 40.5981 -19.9836 6.93831 4.04917 -8347 4 47.6199 17.7956 40.4399 22.5854 -23.5642 7.97707 -8348 4 48.3147 16.8142 41.4747 5.07747 10.2388 -9.33604 -8349 6 32.0284 9.3439 40.0151 10.5149 -12.1651 13.6504 -8350 4 32.8546 9.41316 39.523 -1.99935 -3.17675 -6.39298 -8351 4 31.9706 8.39334 40.2816 -10.0936 21.7982 -4.27543 -8352 6 31.75 22.4929 6.3685 -34.2181 3.54143 23.53 -8353 4 31.3779 21.709 6.82557 12.2201 6.35834 -11.7559 -8354 4 31.3059 23.2194 6.8777 16.0591 -13.7554 -15.3432 -8355 6 51.0144 2.58529 21.579 28.4772 -3.64411 10.4611 -8356 4 51.4343 1.72703 21.8198 -11.0001 9.38403 -4.71992 -8357 4 51.7571 3.20177 21.4507 -11.3685 -6.83795 2.38662 -8358 6 13.6247 22.0465 12.1442 29.0901 0.46256 9.76546 -8359 4 14.4578 22.3795 12.5465 -13.9989 1.27328 -8.95219 -8360 4 12.915 22.6494 12.3833 -3.04453 8.5056 -1.94564 -8361 6 23.6209 24.0381 14.6453 -17.5202 11.834 -36.5316 -8362 4 24.2009 24.4886 15.2598 9.8869 4.60732 -3.70937 -8363 4 23.5497 24.6116 13.8304 3.00595 -20.2815 30.972 -8364 6 9.32136 4.85156 31.2387 8.97842 0.466865 -3.67014 -8365 4 8.41764 4.8259 30.9291 -8.7496 -0.132795 -7.84821 -8366 4 9.23666 5.38964 32.029 2.44443 -3.9247 9.21777 -8367 6 16.6769 26.3146 18.0426 -28.7898 -24.0576 -1.25383 -8368 4 15.7763 26.5978 17.7405 22.2361 3.17889 2.46191 -8369 4 17.2688 27.0532 17.9767 7.52301 23.5471 -7.71583 -8370 6 5.12002 13.5179 11.5454 -28.2867 15.553 -42.5279 -8371 4 4.34318 13.4159 12.0982 -3.89331 -5.54815 13.62 -8372 4 4.69334 13.8537 10.6805 23.3071 -7.58808 40.5266 -8373 6 29.613 23.6535 8.07622 4.06305 -5.39054 -18.0309 -8374 4 29.2087 23.3655 8.89798 -2.48969 6.78204 1.65997 -8375 4 29.356 24.5861 7.97247 8.33853 -10.6544 5.22118 -8376 6 0.809058 7.56442 27.8431 6.90575 4.16885 -14.0934 -8377 4 0.916059 7.33161 28.7668 -1.2645 -7.40385 9.39857 -8378 4 1.47033 8.27499 27.7095 -9.19662 -21.8408 -1.77541 -8379 6 15.4183 9.78145 0.490529 10.0725 -7.13925 0.979932 -8380 4 16.087 9.43012 41.8027 -0.259761 -4.12548 -6.98761 -8381 4 15.4693 9.20893 1.26423 -1.27146 5.63374 6.96511 -8382 6 18.8191 0.059487 34.1187 -25.6574 -0.396319 -31.4644 -8383 4 18.4098 41.5755 33.3103 16.2128 4.97009 18.3796 -8384 4 18.5054 0.975155 34.0945 0.533414 5.37151 1.64989 -8385 6 18.7349 30.7803 29.1665 47.4813 -67.7405 25.7886 -8386 4 19.5534 30.6866 29.7899 -42.3671 12.2249 -32.0712 -8387 4 18.5184 31.6699 29.0545 -8.91834 48.7901 3.3651 -8388 6 48.4474 16.4903 36.136 -4.39653 9.55775 -4.4164 -8389 4 47.5651 16.9082 36.2181 15.0357 -0.381514 0.207393 -8390 4 48.471 16.1274 35.2331 3.08724 1.10756 7.15907 -8391 6 43.7979 0.472205 29.2706 42.555 -4.96452 -15.1149 -8392 4 42.8863 0.267919 29.38 -32.9664 -6.64218 10.9475 -8393 4 44.2792 41.5357 29.3524 -8.26894 11.2804 8.78801 -8394 6 16.7205 13.887 21.3769 2.19577 2.66609 -2.49996 -8395 4 16.2052 14.7022 21.5336 6.85381 -11.1318 0.719729 -8396 4 16.6911 13.4037 22.2072 -6.06459 1.50462 5.19021 -8397 6 17.3883 13.4356 26.2524 27.4966 3.2637 -26.6685 -8398 4 18.1303 13.5822 25.5825 -26.8694 -2.13737 32.6247 -8399 4 17.6394 12.6216 26.7148 -3.51452 -0.718268 0.201186 -8400 6 48.1557 10.2329 23.6958 7.66187 -11.6345 21.9365 -8401 4 48.0869 10.5828 24.5972 -4.20109 -8.3855 -4.21906 -8402 4 47.9242 10.9774 23.1563 3.12678 5.33996 -12.4543 -8403 6 28.2651 17.9126 17.8865 15.704 23.8601 -19.8805 -8404 4 29.0328 18.4581 17.6288 -8.16305 -6.08358 1.86534 -8405 4 28.6272 17.0995 18.2183 0.672722 -20.799 10.0784 -8406 6 54.0866 38.1772 23.6885 15.2416 -7.03948 -9.32302 -8407 4 0.015845 37.9236 23.4759 -13.1891 10.5947 7.1207 -8408 4 53.5403 37.6177 23.1226 -4.14834 -2.69562 5.50015 -8409 6 8.47885 18.3973 11.4073 -18.4373 -13.8141 42.9629 -8410 4 7.63335 18.6519 11.0416 -6.40415 6.02722 -6.48684 -8411 4 9.12927 18.583 10.7796 32.3175 8.52747 -41.6205 -8412 6 45.9451 12.8796 11.0371 -17.0736 -2.86831 -37.3051 -8413 4 46.6905 12.613 10.4807 4.61659 2.073 6.35499 -8414 4 45.2044 12.775 10.3831 8.06265 2.44535 24.075 -8415 6 16.2127 8.79404 14.0297 41.7324 -66.6139 22.361 -8416 4 15.4739 9.28873 13.8367 -45.7772 50.9633 -18.0772 -8417 4 17.0286 9.27652 14.012 9.93977 26.888 -8.08533 -8418 6 42.7214 13.3612 21.3881 16.6788 44.7105 -2.77317 -8419 4 41.8036 13.1589 21.3301 -20.1042 -28.5105 -1.62877 -8420 4 42.6833 14.2978 21.1276 5.52546 -8.26362 1.62797 -8421 6 21.0018 40.4256 16.4674 21.2457 -19.0828 1.73859 -8422 4 20.7372 40.049 17.3276 2.67731 3.65462 -7.46566 -8423 4 21.8606 39.9985 16.1939 -29.0987 10.293 9.55187 -8424 6 45.6337 11.4313 32.9356 51.1157 -40.0447 2.01383 -8425 4 46.3303 10.7696 33.2563 -29.172 28.0234 -20.2541 -8426 4 45.1866 11.676 33.7277 -20.3741 9.53259 21.5498 -8427 6 26.9484 8.87146 24.2965 48.4346 1.85391 18.4292 -8428 4 27.5311 9.68141 24.3337 -29.9021 -15.2605 -8.39328 -8429 4 27.4823 8.26118 24.8676 -16.4416 6.67878 -12.0087 -8430 6 18.977 2.43413 29.3663 0.758316 16.52 -7.40381 -8431 4 18.1944 2.4248 29.9271 -0.767207 -2.12047 7.99903 -8432 4 19.1173 3.36872 29.101 -3.03797 -9.07666 7.57415 -8433 6 8.2454 29.1679 19.723 -8.63488 -12.9151 21.1286 -8434 4 8.14448 28.8871 20.6627 3.14293 7.67545 -21.2948 -8435 4 7.83715 28.464 19.1969 -1.03495 3.62674 2.54809 -8436 6 9.03976 34.3129 18.6533 -7.54593 -6.72093 -3.09965 -8437 4 8.77081 34.2931 19.577 -0.177883 2.97642 -7.59668 -8438 4 9.06659 35.2455 18.4187 6.50563 1.62734 -4.46359 -8439 6 10.1892 11.9266 11.2355 -21.5107 11.0325 -1.739 -8440 4 10.2333 12.874 11.065 17.4692 -2.43612 -1.88546 -8441 4 9.23632 11.7983 11.121 5.09535 -6.80078 4.24402 -8442 6 35.7546 21.6858 36.1669 -23.2352 21.9394 0.834429 -8443 4 35.0265 22.3595 36.1433 18.2091 -18.4066 2.26802 -8444 4 36.3924 22.0173 36.8321 -9.99636 -6.87572 -9.75527 -8445 6 17.0812 12.5048 36.3903 -12.1142 25.6516 12.5185 -8446 4 17.3175 12.8308 37.2812 -0.49448 -9.18651 -10.1264 -8447 4 17.5662 11.7075 36.2155 7.76979 -20.5663 -1.07791 -8448 6 37.1566 13.0227 34.2843 -17.9764 -6.1284 -55.2853 -8449 4 36.5549 12.2662 34.3472 4.68366 1.60167 -17.3784 -8450 4 37.3932 13.1268 35.1567 14.9075 13.7384 64.605 -8451 6 38.9862 29.5501 13.2301 -1.89389 21.6683 -7.70005 -8452 4 38.7944 28.7085 12.8419 -2.19861 -17.9948 -10.7911 -8453 4 38.6501 29.4932 14.1174 1.27468 3.77518 16.782 -8454 6 0.176516 29.3495 29.4845 -12.5141 10.2637 -5.31555 -8455 4 0.737394 28.6151 29.2028 3.82179 3.49987 -8.15609 -8456 4 54.9814 29.9211 28.6995 5.57042 -17.7863 13.6106 -8457 6 15.9458 0.256833 12.7596 -44.0073 4.56069 2.48191 -8458 4 15.316 0.578271 12.0799 19.6091 -0.692249 -3.06606 -8459 4 15.3039 41.7798 13.3939 19.5978 -0.7471 3.56907 -8460 6 3.99127 11.9482 8.78851 -15.4327 -39.7622 32.4444 -8461 4 4.35413 11.6179 7.97869 6.27746 3.41828 -23.4587 -8462 4 3.98972 12.8788 8.75552 1.02746 43.1268 -6.73396 -8463 6 24.041 23.6822 19.9783 33.1595 11.366 0.122861 -8464 4 23.6132 22.8866 19.7159 -20.0299 -17.1205 -2.84168 -8465 4 23.4218 24.2757 20.3917 -9.46777 4.2557 4.80954 -8466 6 4.48057 2.29323 23.9805 -22.9759 10.1361 69.4322 -8467 4 4.73792 2.40802 23.1034 3.49419 10.2026 -52.1527 -8468 4 3.69711 2.85929 24.1902 11.7092 -10.5693 -13.4065 -8469 6 33.0966 27.663 33.8386 -28.073 -12.9468 -7.71443 -8470 4 33.3687 28.5694 33.7309 6.85765 13.8135 -2.76136 -8471 4 33.7449 27.1385 34.2981 13.436 1.78162 12.2729 -8472 6 11.3912 21.7129 6.08719 -17.5666 -2.19741 -2.39462 -8473 4 12.3323 21.6847 6.05692 28.5529 -3.65784 2.285 -8474 4 11.1694 22.1681 5.26899 -4.22105 -2.6604 -2.39966 -8475 6 37.2225 13.5364 23.6261 -18.6729 23.2035 4.88571 -8476 4 37.3138 14.0862 24.4412 -7.0733 -14.7121 -13.3014 -8477 4 37.9734 12.9786 23.5155 30.7338 -8.31921 -1.90296 -8478 6 5.00503 21.0366 33.3647 1.8453 38.5327 -33.3657 -8479 4 4.21257 21.4237 32.9267 15.1329 -13.9269 -2.57683 -8480 4 4.69097 20.5075 34.0602 -12.1996 -25.3348 31.8286 -8481 6 18.1998 37.5792 26.9379 10.6598 2.97497 -14.5277 -8482 4 17.7896 38.4267 27.1371 3.99806 -1.69574 -0.528064 -8483 4 18.8493 37.7746 26.2284 -6.0853 -8.42077 12.5802 -8484 6 19.7447 16.1537 4.6847 3.25094 -1.99961 -5.02271 -8485 4 18.927 15.8729 5.11398 3.02189 5.09699 3.93014 -8486 4 20.4865 15.8366 5.22215 -5.31395 3.35724 3.77112 -8487 6 54.074 32.5125 15.5854 10.3761 -37.3618 -30.9158 -8488 4 54.8842 32.2065 16.0104 -1.29748 4.29224 -6.87141 -8489 4 53.7047 33.0976 16.2003 -18.9781 34.1452 25.1436 -8490 6 31.1314 3.81684 36.7321 -0.834289 -2.49025 -7.10722 -8491 4 31.1103 4.02948 37.6722 -6.54843 -2.60835 4.18586 -8492 4 30.7135 2.95482 36.5673 3.74099 5.55874 7.56308 -8493 6 11.8386 14.3591 5.9475 31.6488 6.08621 47.6135 -8494 4 11.9235 13.4381 5.72501 -3.84758 -8.60837 -9.73648 -8495 4 12.4264 14.4198 6.78937 -30.0453 0.761866 -39.8937 -8496 6 30.4739 33.6971 6.46755 -23.3776 20.1936 16.0158 -8497 4 30.0841 33.0849 7.09297 -6.22519 -2.1618 10.9649 -8498 4 31.0937 33.1726 6.0102 25.8315 -23.5027 -25.5745 -8499 6 12.7945 0.536645 21.6661 -31.9857 18.4102 -14.2222 -8500 4 12.046 0.975194 21.1709 21.6431 -18.6961 6.09473 -8501 4 12.7507 0.998686 22.5059 13.427 -0.157027 11.5383 -8502 6 52.7685 7.22113 26.1957 6.97037 27.5507 21.845 -8503 4 53.4259 7.92282 26.4698 -21.5773 -21.2317 -16.9414 -8504 4 53.0823 6.78628 25.4103 4.46247 -3.68205 -10.7225 -8505 6 39.7279 40.8849 3.7445 22.9677 17.8938 -40.8272 -8506 4 39.3244 40.0392 3.76563 -12.6427 -25.5287 10.0743 -8507 4 39.6614 41.3038 4.58361 -3.65945 6.85452 27.763 -8508 6 20.1085 31.9188 21.9984 -7.05206 -5.67602 7.13377 -8509 4 19.4287 32.0842 22.6964 14.9272 -8.91322 -13.6161 -8510 4 20.3617 32.7769 21.6609 2.64243 15.0084 0.0829653 -8511 6 12.8674 35.0052 4.44359 43.5281 -46.0898 9.1613 -8512 4 12.2643 35.7062 4.40975 -34.4326 42.8527 -2.74399 -8513 4 13.784 35.3443 4.35073 -14.7319 6.47242 -4.65586 -8514 6 24.0589 33.6612 24.8588 9.55704 11.7193 -6.52578 -8515 4 23.7303 32.9012 24.3903 -5.13736 -12.3884 -10.0474 -8516 4 24.8786 33.8838 24.3903 -2.58553 -1.28908 -1.69824 -8517 6 40.1426 40.9082 22.7393 38.5538 -20.8809 37.5387 -8518 4 39.5402 41.0833 22.0513 -32.6743 7.60774 -19.3027 -8519 4 39.6696 40.5795 23.5226 -1.01773 2.4492 -9.99125 -8520 6 15.5532 2.81426 38.4448 -20.0738 34.0709 23.3703 -8521 4 14.8967 3.48174 38.7749 9.17215 -23.4566 -12.8824 -8522 4 16.1607 3.33672 37.9186 19.8661 -0.634992 -1.43825 -8523 6 41.016 9.18565 16.9561 17.4117 -10.7022 -18.9926 -8524 4 41.8597 8.69641 16.8054 -9.41989 12.8418 6.23764 -8525 4 40.6131 8.73354 17.6887 -9.17188 -2.41438 15.2761 -8526 6 43.1923 41.3931 9.58697 -22.3356 -19.1489 -3.62619 -8527 4 42.3612 40.9845 9.24256 14.3618 0.824315 8.65898 -8528 4 43.3433 0.185675 8.9708 1.58778 19.1204 -6.9238 -8529 6 24.903 37.9158 30.7914 -43.8554 -5.41491 21.3724 -8530 4 23.952 37.804 31.173 48.4757 4.96182 -14.1951 -8531 4 24.7905 38.4252 29.9913 -4.69729 3.46822 -12.8277 -8532 6 2.22055 5.32897 16.4318 -0.704957 11.5959 2.51569 -8533 4 1.8086 4.56809 16.8519 3.25773 -6.94195 4.1641 -8534 4 3.17492 5.17974 16.3235 -2.45649 -10.6256 -1.35481 -8535 6 1.39662 14.9371 19.1386 6.71081 10.2639 18.1623 -8536 4 0.558182 14.6006 18.8448 -10.0768 -10.7254 -15.2923 -8537 4 1.25744 14.8844 20.1022 8.06638 5.64899 -3.4629 -8538 6 34.3184 26.5435 23.7018 12.956 38.2174 -10.8067 -8539 4 33.6096 26.6326 23.0506 -6.28704 -5.42218 7.19498 -8540 4 34.253 25.729 24.1673 -8.0715 -30.4977 4.91012 -8541 6 41.932 21.8144 37.5476 -28.1346 24.458 10.6264 -8542 4 41.9653 21.2973 38.3662 8.82952 -0.726087 -9.88338 -8543 4 41.2985 22.5209 37.8344 14.7394 -10.5077 -10.9774 -8544 6 39.4289 37.6722 12.6363 -7.06663 36.6798 -8.56095 -8545 4 38.7214 38.0767 13.1674 9.12422 -13.2372 3.4836 -8546 4 39.8791 38.4903 12.2996 -0.376717 -30.7746 7.3995 -8547 6 30.2308 35.8744 2.88429 56.3256 -5.17531 19.584 -8548 4 29.7395 35.078 2.8871 -14.5394 -27.2578 -4.40621 -8549 4 29.6846 36.541 2.55195 -33.266 39.3858 -14.7027 -8550 6 50.3691 12.2996 11.0379 -10.7742 -32.245 -38.7061 -8551 4 50.5492 13.1381 11.4098 4.20277 26.7051 25.7379 -8552 4 50.0731 11.6929 11.7162 -2.05651 -3.66514 15.0978 -8553 6 38.4203 1.52686 34.6552 6.3891 -23.1477 32.9209 -8554 4 38.2942 1.9363 33.8354 -7.66336 30.6162 -40.7111 -8555 4 38.1079 0.632206 34.5078 -6.35148 -11.0336 -1.97829 -8556 6 23.4679 32.2557 29.2149 -43.4567 -12.6916 53.2324 -8557 4 24.0296 32.8423 28.7424 12.6247 17.2837 -9.6693 -8558 4 23.1232 32.6929 30.0761 24.9901 -11.6617 -44.232 -8559 6 36.561 38.8488 8.89417 42.7368 2.70764 46.8348 -8560 4 35.962 39.5202 8.64255 -29.9788 24.4889 -23.0747 -8561 4 36.8832 39.1244 9.78764 -11.193 -6.37855 -17.8717 -8562 6 35.882 15.8491 32.4345 4.38917 24.4094 -11.8898 -8563 4 36.1253 15.4284 33.2547 4.1797 -3.844 11.2859 -8564 4 36.4849 16.63 32.3181 -12.6028 -21.8682 2.29862 -8565 6 22.2747 21.8257 41.5848 1.63659 45.0851 -0.0273952 -8566 4 22.1351 22.8132 41.5538 -4.13496 -33.3395 13.1468 -8567 4 23.0832 21.7834 41.079 15.3069 -18.439 -3.51535 -8568 6 24.3693 38.6933 37.0124 5.99709 22.8296 -9.01594 -8569 4 25.2224 39.1901 37.0147 -13.2325 -18.2305 -0.0611307 -8570 4 24.4452 38.0141 37.6805 1.8393 -10.9749 7.25289 -8571 6 45.85 22.0674 16.0435 -6.35855 -11.009 -33.5755 -8572 4 46.1693 22.2375 15.1223 -5.70657 5.73574 25.2515 -8573 4 45.3177 21.2496 15.9445 13.424 8.98362 5.88408 -8574 6 34.0938 26.1451 39.6028 29.3502 -8.72422 32.5359 -8575 4 33.1775 26.2044 39.4639 -36.6108 3.5864 -15.8394 -8576 4 34.1454 26.1252 40.583 9.60862 3.8872 -14.9166 -8577 6 7.22316 36.161 23.2803 -75.9344 2.48999 -44.2827 -8578 4 7.2061 37.0658 22.9632 2.60813 8.07149 -4.69042 -8579 4 7.98979 36.1134 23.7455 79.8131 -8.28428 52.3852 -8580 6 29.1469 40.7664 9.14908 25.9603 -62.9641 -41.536 -8581 4 29.104 40.2522 8.28913 -11.1672 35.4313 19.904 -8582 4 29.7179 40.1086 9.59652 -3.22944 23.7461 21.8778 -8583 6 29.3725 11.2348 1.3024 -38.7794 14.8627 17.4065 -8584 4 28.4703 11.3821 0.891273 31.6728 -0.63192 16.6295 -8585 4 29.2803 11.4968 2.26097 5.36173 -12.1272 -32.3877 -8586 6 30.9813 3.70043 14.0775 0.393287 -12.1193 -7.6118 -8587 4 31.3533 2.81844 14.3971 -7.37725 32.1126 -17.4345 -8588 4 30.796 3.71521 13.098 8.52465 -17.2224 25.8707 -8589 6 29.7018 15.2871 38.2765 -11.7342 18.5436 -44.4423 -8590 4 30.2882 15.1814 38.9925 24.3773 -7.28175 32.8118 -8591 4 30.1059 15.9805 37.6877 -12.7379 -16.9908 17.8861 -8592 6 36.618 0.316233 29.1564 -1.13478 17.6011 -18.8673 -8593 4 37.4497 0.805382 29.2328 -0.537074 -5.31334 10.7084 -8594 4 36.0611 0.935156 28.6408 3.38103 -20.3125 11.7491 -8595 6 47.6566 0.117823 23.249 5.11875 5.73062 -10.5794 -8596 4 46.969 0.414744 23.8324 -12.4062 9.53281 16.9836 -8597 4 47.4018 41.1354 23.0496 0.315762 -17.3342 0.264415 -8598 6 7.91605 37.1729 29.9478 9.96828 38.7234 29.3851 -8599 4 7.8238 37.3188 30.9485 4.22886 -13.4646 -46.5453 -8600 4 8.48708 37.9472 29.6677 -24.8232 -29.7333 9.09982 -8601 6 38.925 24.2263 12.6374 28.6028 -18.1679 -25.4959 -8602 4 37.978 24.1747 12.7226 -16.6271 -1.4443 2.40459 -8603 4 39.1586 23.5255 11.9538 -9.24307 26.9603 22.464 -8604 6 21.3053 26.2545 36.7859 14.9917 45.9325 1.16 -8605 4 20.8074 25.7232 36.1994 -14.2562 -21.9874 -17.8757 -8606 4 21.6248 25.6951 37.4625 3.91421 -21.0802 23.8691 -8607 6 28.2258 23.3284 24.9888 19.6442 1.87868 9.60148 -8608 4 28.2493 24.0261 25.6588 -3.93467 -3.60043 -2.01642 -8609 4 29.1002 22.8932 25.0573 -18.3502 1.43704 -4.70914 -8610 6 38.4116 39.5691 14.5896 29.669 -4.24194 25.1928 -8611 4 38.4978 38.8692 15.3261 -6.52385 31.9806 -37.1925 -8612 4 39.2924 40.0897 14.6163 -46.5668 -30.9815 -6.21074 -8613 6 26.0432 5.99751 38.1148 44.5658 1.98351 30.7371 -8614 4 26.452 6.86444 38.1066 -12.5768 15.2327 -11.4433 -8615 4 26.7959 5.51316 38.5398 -27.2991 -6.53191 -16.0548 -8616 6 52.1237 17.2497 22.5073 -27.4301 16.765 14.7973 -8617 4 52.9399 17.665 22.2571 16.5652 5.20466 -11.3284 -8618 4 52.1578 16.3131 22.3678 7.8945 -19.2066 -9.92552 -8619 6 39.5302 30.1999 31.4498 -15.3908 2.56685 75.4769 -8620 4 40.0207 30.5437 32.2484 0.473519 -4.28305 -35.1019 -8621 4 38.713 29.8928 31.926 18.6512 10.8404 -28.7426 -8622 6 19.6503 6.93083 12.7623 15.8343 -24.4908 21.6207 -8623 4 19.8732 6.46228 13.5959 -20.1786 11.9342 -5.76682 -8624 4 20.303 6.55009 12.1776 -0.0209149 2.55819 -14.5973 -8625 6 32.4196 37.4972 40.0987 12.4446 10.4582 -32.0511 -8626 4 32.8186 36.647 40.0719 9.51079 -23.9505 -16.9607 -8627 4 32.1638 37.519 40.9804 -20.9873 13.1856 56.2462 -8628 6 39.7646 0.344956 6.09395 -0.813604 -13.3118 11.6504 -8629 4 40.0929 1.25666 6.05063 3.72657 -6.06719 5.14874 -8630 4 40.1279 41.7919 6.88268 -2.2039 13.7644 -10.8213 -8631 6 28.7754 10.1494 29.1547 6.27663 8.45441 -17.0952 -8632 4 27.8341 10.1814 28.9557 -5.13507 -0.906004 3.81537 -8633 4 28.9096 9.91312 30.0774 -3.02611 -6.60467 -0.689697 -8634 6 28.3509 21.0738 10.6423 20.1214 -0.517468 -23.7169 -8635 4 28.7452 21.9678 10.604 -10.1652 -7.70852 11.001 -8636 4 28.9796 20.5469 10.1008 -17.263 7.26144 14.8814 -8637 6 27.0689 28.6853 20.8654 35.4789 -5.63144 4.47554 -8638 4 27.7442 29.2307 21.3162 -7.53329 -4.62114 -3.00727 -8639 4 26.2324 28.9644 21.1916 -29.8949 8.87289 15.491 -8640 6 39.6884 13.9755 33.4499 14.6401 2.99861 16.5486 -8641 4 40.0373 13.7827 34.3426 -3.85296 -1.51256 -14.2832 -8642 4 38.7457 13.8219 33.5285 -9.87208 -9.87778 -3.27097 -8643 6 25.4679 11.6581 34.316 -5.2989 -28.5582 40.5924 -8644 4 24.7613 11.1605 34.7897 20.9725 -0.466275 -6.59756 -8645 4 25.003 12.0579 33.6214 -16.717 25.3404 -32.2266 -8646 6 27.5101 37.647 21.4263 -39.7295 -31.2682 -35.969 -8647 4 28.2375 37.1633 21.0518 17.2189 -6.02702 -9.55939 -8648 4 27.8241 38.1534 22.1272 30.3423 24.6719 41.8853 -8649 6 30.5838 20.0489 28.6446 73.221 13.9737 -1.42059 -8650 4 31.1441 19.3945 29.1273 -28.9524 12.9537 -8.0961 -8651 4 29.6632 19.9528 28.6439 -45.0502 -19.2043 6.90743 -8652 6 42.3833 1.8554 14.9243 13.367 3.08275 38.4467 -8653 4 41.8907 2.29225 15.634 5.99337 6.74303 1.17955 -8654 4 41.7769 1.84183 14.2131 -17.6385 -4.20156 -32.9301 -8655 6 12.1633 12.5377 19.5325 -23.0245 -19.867 -11.1113 -8656 4 12.9521 12.0237 19.3369 9.43068 0.576721 5.46819 -8657 4 11.4219 11.8853 19.4518 12.4737 16.4774 1.27947 -8658 6 19.216 1.20416 16.3541 12.5689 2.54581 22.2585 -8659 4 19.6937 0.628292 16.9879 -4.91383 6.35485 -14.1526 -8660 4 19.7889 1.98236 16.2594 -2.22189 -4.72354 -7.2618 -8661 6 9.47695 16.1439 27.6873 23.0793 15.684 -40.8775 -8662 4 9.87411 15.9669 26.7875 -8.00596 11.4199 30.6292 -8663 4 9.27844 15.2819 28.0019 -12.6146 -24.0632 14.4486 -8664 6 40.4558 26.1873 24.7848 -5.87099 -8.07067 -10.9608 -8665 4 40.3772 26.6753 25.6381 -3.45584 0.121614 -18.2296 -8666 4 40.075 26.6842 24.0102 9.21367 0.234889 33.0434 -8667 6 47.6742 17.6493 18.027 -37.0889 26.6143 -3.73366 -8668 4 48.2089 18.0323 18.7522 -4.76487 -3.2939 -8.20899 -8669 4 46.8388 18.2201 17.9217 41.9344 -19.3622 12.4897 -8670 6 36.6073 25.2802 4.19388 18.2149 -9.73143 -24.5863 -8671 4 36.604 25.3887 5.14943 -0.00537736 13.7381 3.83127 -8672 4 37.3627 25.7621 3.76942 -18.9403 0.329358 18.8416 -8673 6 39.5721 35.375 29.6682 7.39129 29.0443 4.37935 -8674 4 38.9992 34.6325 29.7528 -8.39079 -18.7886 -5.10368 -8675 4 39.3389 35.9401 30.4162 6.41301 -4.37294 -4.4287 -8676 6 0.402862 14.6299 13.3406 12.3375 -5.37043 -32.3015 -8677 4 54.737 15.2477 13.6388 -5.18731 7.44473 4.40324 -8678 4 0.540834 14.0191 14.0401 1.19186 -14.994 25.3978 -8679 6 12.2127 27.3484 8.43247 -29.2387 -0.771708 1.75024 -8680 4 12.965 26.7512 8.46983 14.5311 5.0326 6.8656 -8681 4 12.3156 28.1607 8.97491 11.1816 -11.3427 -11.9337 -8682 6 36.8986 14.8167 21.1188 31.0797 27.7575 -31.2238 -8683 4 37.0397 14.394 21.9547 2.6333 -10.7207 26.6181 -8684 4 37.7308 15.3371 20.9125 -24.2604 -24.0664 4.77074 -8685 6 20.8464 4.94114 21.1044 31.4042 5.97012 13.2179 -8686 4 20.3644 5.60924 21.5958 -5.50293 4.43366 -4.7096 -8687 4 21.773 5.03668 21.4416 -23.5272 -13.3128 -11.683 -8688 6 36.7544 1.79945 7.61694 -30.3574 47.6061 45.3867 -8689 4 36.327 2.6686 7.87118 16.8784 -26.1974 -29.8241 -8690 4 36.8428 1.50799 8.53455 15.1793 -22.3797 -11.8231 -8691 6 12.2439 31.5023 37.4569 -32.4985 -2.96535 6.06153 -8692 4 12.7586 31.1596 36.7365 10.4364 1.05198 -9.11954 -8693 4 11.3919 31.0227 37.3953 11.2973 8.58078 9.3944 -8694 6 38.9908 41.586 16.881 -5.73716 8.1645 -10.5856 -8695 4 39.3046 41.7073 15.9766 4.30886 -9.33368 3.06156 -8696 4 39.3667 0.405687 17.3669 3.77504 10.3777 9.96207 -8697 6 31.8904 27.2678 22.2602 -2.97266 4.85738 -46.2508 -8698 4 31.2122 26.6002 22.3915 1.88455 0.488126 10.0993 -8699 4 31.7489 27.4981 21.2895 3.71213 -3.79941 38.8104 -8700 6 42.7405 9.18554 25.589 -22.1194 -12.6454 -9.25487 -8701 4 42.0872 8.82691 24.9599 0.650449 1.17306 7.26361 -8702 4 43.4011 9.54846 25.0154 21.3216 10.0262 -4.62936 -8703 6 50.9383 28.1736 25.3544 -13.6318 0.0171378 28.1732 -8704 4 50.4953 27.5553 24.7803 -5.9639 1.72187 -15.2616 -8705 4 50.5272 27.9992 26.2251 14.2447 5.57945 -12.3971 -8706 6 43.1888 19.6578 30.9105 -66.6531 23.7889 25.5358 -8707 4 44.0873 19.829 30.8982 70.1332 9.75906 -5.84371 -8708 4 42.7965 20.4661 31.3425 9.97757 -17.7871 -10.1322 -8709 6 30.6644 14.0457 40.7997 -18.1309 16.7334 54.243 -8710 4 30.3214 14.3504 41.7092 15.0959 -2.90855 -40.5845 -8711 4 30.1739 13.231 40.7145 -1.19418 -16.8866 -12.4659 -8712 6 20.9131 15.4897 23.0235 5.61878 12.7036 12.8066 -8713 4 20.368 16.1905 23.4302 1.66694 -9.32372 -6.67403 -8714 4 21.8218 15.751 23.2692 -7.37195 -9.57776 -6.18749 -8715 6 34.2171 0.764056 35.8253 8.40959 -35.3498 44.9304 -8716 4 34.6567 1.46863 36.3417 -5.08936 -9.30099 -7.81199 -8717 4 34.1194 41.866 36.4755 2.29033 39.9746 -37.3302 -8718 6 38.9162 36.9098 35.9203 10.0793 6.80115 3.36275 -8719 4 39.7784 37.1612 36.3284 -16.0364 -11.2649 -5.21842 -8720 4 38.6132 36.0588 36.2696 9.66804 2.35098 0.533126 -8721 6 45.1336 25.2146 22.7744 -28.8992 3.863 21.2581 -8722 4 44.1561 25.0943 22.7165 17.1243 8.87651 18.653 -8723 4 45.3983 24.7563 22.0047 17.0602 -12.3694 -29.5411 -8724 6 40.597 0.8134 35.9421 3.227 69.6319 -3.88491 -8725 4 40.5509 41.8059 36.0096 -6.03355 -53.2669 -4.53187 -8726 4 39.9427 1.13471 35.2813 10.0151 -17.6297 16.5691 -8727 6 11.0455 28.3465 35.0235 9.7668 1.71998 -0.601403 -8728 4 10.9819 27.7367 35.7737 -0.960779 4.073 1.47136 -8729 4 10.3922 29.0422 35.1677 -11.8786 -4.48184 3.12795 -8730 6 20.2051 13.5934 35.8566 39.7213 -43.4527 45.4399 -8731 4 19.4813 14.0017 35.4777 -48.9883 30.031 -35.164 -8732 4 20.9868 14.0394 35.5673 14.4182 15.1 -18.5178 -8733 6 39.6245 5.13776 1.76997 -0.951619 9.89005 21.073 -8734 4 38.8252 4.77089 1.41386 -14.9185 -6.12031 -3.7056 -8735 4 40.3018 4.93211 1.13633 15.4903 5.30459 -14.5773 -8736 6 30.2698 30.8736 32.4375 -6.71798 15.6036 14.0469 -8737 4 29.6901 31.1438 33.1751 5.76607 1.99955 -8.25679 -8738 4 29.7896 30.1731 32.0039 1.14172 -17.9152 -6.50707 -8739 6 14.5598 11.0088 22.8703 10.5759 -0.53797 13.7125 -8740 4 15.2344 11.6195 23.3114 -32.0235 -23.0075 -11.5695 -8741 4 13.848 10.7777 23.5118 19.1574 10.2796 -1.34673 -8742 6 20.7379 13.9443 3.00881 5.16887 -45.0314 -26.4616 -8743 4 19.9261 13.6658 2.50706 22.866 18.233 23.793 -8744 4 20.5244 14.6819 3.55007 -16.1173 25.3417 12.2311 -8745 6 41.3029 4.28468 12.6203 -8.04128 10.917 21.7417 -8746 4 40.6152 3.63858 12.7642 -6.82471 -4.23516 2.09603 -8747 4 41.6484 4.11485 11.7651 11.719 -9.67534 -28.974 -8748 6 10.8581 24.7328 21.7161 -39.3585 -15.8792 -33.4515 -8749 4 10.0068 24.8598 21.1989 28.1112 14.2693 20.1969 -8750 4 11.1639 23.9123 21.3137 10.3572 -6.50453 7.69671 -8751 6 53.5762 20.8825 34.3773 -29.6915 -0.0415475 -3.94304 -8752 4 54.5085 20.795 34.3185 33.8519 4.29786 -2.30511 -8753 4 53.2552 20.0612 34.7861 8.83511 12.9473 -9.59804 -8754 6 14.8838 4.84499 30.449 -1.65326 0.839716 -13.8987 -8755 4 14.8578 5.00753 29.4799 -4.93385 -7.75961 17.951 -8756 4 14.5437 3.94124 30.5804 2.28716 7.27432 -2.63088 -8757 6 48.9137 37.1159 13.1232 -44.1315 32.6594 -31.0851 -8758 4 47.9268 37.1149 13.1949 24.5681 4.85746 10.1076 -8759 4 49.2024 36.4546 13.7037 17.9017 -30.2536 24.0784 -8760 6 26.8017 19.3068 7.5379 -15.1037 -1.6612 14.6377 -8761 4 27.3245 18.5243 7.34583 -2.01051 -6.65035 -9.19035 -8762 4 27.3053 20.0577 7.2492 18.4232 10.5976 -10.0514 -8763 6 17.631 11.9383 39.0904 -43.3265 13.8677 10.122 -8764 4 18.4941 11.6307 38.9203 38.4816 -13.6738 2.54756 -8765 4 17.5009 12.0978 40.0481 6.31677 -1.58465 -10.4285 -8766 6 49.9233 14.5931 8.61354 5.83785 -36.2985 -8.08798 -8767 4 49.214 13.9285 8.60404 6.89175 6.08198 5.75816 -8768 4 49.5175 15.3796 8.93642 -5.42274 33.9852 6.11405 -8769 6 32.3642 34.9667 31.5078 2.95354 23.7899 20.5819 -8770 4 32.072 34.4222 30.8036 -4.84614 -18.7532 -16.6478 -8771 4 32.4643 35.8463 31.1217 -0.970967 -0.757054 5.3462 -8772 6 11.8286 22.2266 21.3061 -17.2258 -15.6378 -41.9552 -8773 4 12.2171 21.6669 20.5638 -11.8041 19.7065 26.8676 -8774 4 12.3859 22.1258 22.0497 29.6948 -3.02551 21.8379 -8775 6 33.8509 9.96106 13.6416 -14.3875 -24.3714 -53.1057 -8776 4 33.0123 9.50508 13.4028 8.15621 17.9807 22.2309 -8777 4 34.3201 9.78154 12.7883 7.50726 12.1846 28.7729 -8778 6 25.5192 36.3946 1.51103 -10.4602 3.19395 -11.4439 -8779 4 26.0842 36.7323 0.810141 8.62195 6.50952 5.56913 -8780 4 24.6933 36.9065 1.40961 6.72848 -10.059 1.65156 -8781 6 26.2721 10.5411 9.76409 -19.2005 -4.19702 2.88354 -8782 4 25.6096 11.193 9.42675 5.9346 -6.99241 18.1855 -8783 4 25.839 9.94226 10.4354 7.43867 25.8511 -14.7334 -8784 6 25.016 0.794303 40.8954 13.3669 6.17095 4.00755 -8785 4 25.3682 0.342397 40.1084 -6.19889 9.04785 1.09472 -8786 4 25.4075 1.69244 40.9338 -2.19893 -14.7289 -5.24662 -8787 6 46.2434 3.93626 24.8203 6.94819 -22.6825 -8.03363 -8788 4 46.3834 4.04208 23.8743 3.61713 6.01616 -2.12387 -8789 4 46.2394 2.96647 24.9181 -8.37252 7.22853 3.62774 -8790 6 21.5889 13.6037 29.2057 4.95103 8.76674 17.4208 -8791 4 21.6019 14.3052 29.8879 -2.51331 -9.966 -5.68557 -8792 4 21.3126 14.082 28.4253 -2.16645 0.501775 -6.52993 -8793 6 36.7737 38.3803 0.360926 -13.0762 -25.442 -6.6792 -8794 4 36.4499 39.0355 0.978203 -4.80976 12.188 0.88021 -8795 4 36.0266 37.7487 0.22189 15.835 12.8395 4.19355 -8796 6 19.3086 17.6338 24.0617 47.0109 35.6134 -17.5995 -8797 4 18.4263 17.3722 24.1632 -50.3154 -15.1751 2.93786 -8798 4 19.3137 18.3511 23.365 -2.62926 -22.9616 14.087 -8799 6 23.1803 12.6945 3.50697 -12.4047 4.12184 -0.296296 -8800 4 22.2521 12.9621 3.30307 10.5621 -3.58256 -0.535563 -8801 4 23.3663 11.8631 3.0578 -9.23841 -1.30096 -1.53094 -8802 6 37.8891 8.88353 35.4651 -18.9945 -25.3999 -47.3866 -8803 4 38.8166 8.83127 35.1934 2.77199 2.98421 7.2207 -8804 4 37.4068 8.32521 34.752 23.9265 29.6152 37.0755 -8805 6 14.3237 15.1253 36.1844 10.7536 -1.62675 -12.1114 -8806 4 15.0418 15.7291 36.3902 7.37284 -3.65767 0.0646607 -8807 4 13.765 15.154 36.9379 -17.7819 2.51157 18.8211 -8808 6 35.0801 0.941274 33.018 -10.8249 30.7834 33.3167 -8809 4 34.9269 1.883 33.2395 6.71896 -7.58638 -28.1375 -8810 4 34.9733 0.615676 33.9226 0.339269 -19.4543 -11.259 -8811 6 50.9271 0.518298 17.9933 -4.01299 -8.33658 -1.61011 -8812 4 50.7551 1.39133 17.5891 -0.713529 -12.5397 8.99793 -8813 4 50.17 41.8323 17.8017 14.8721 13.6567 -6.57092 -8814 6 26.2328 30.5636 0.934374 -8.95911 39.2037 50.9017 -8815 4 26.9657 31.1139 1.27364 -12.5333 -13.1029 -5.86431 -8816 4 26.5352 30.0815 0.207089 19.4446 -20.9762 -37.1203 -8817 6 18.5681 38.3031 4.5613 16.0408 -0.4472 -12.493 -8818 4 17.6336 38.3732 4.40187 -16.7548 5.85511 1.82222 -8819 4 18.9561 38.7121 3.75593 -0.616515 -6.35836 15.3023 -8820 6 31.1349 5.07457 4.1166 35.5071 -12.4218 -11.0008 -8821 4 31.9258 4.61163 4.53765 -37.2933 13.7034 -13.5003 -8822 4 31.2792 5.02565 3.1391 -9.10044 -1.2591 17.9933 -8823 6 26.4378 21.892 1.49191 0.117022 -23.7737 9.75083 -8824 4 26.3504 22.7277 1.07049 4.38069 30.3527 -12.7348 -8825 4 27.3618 21.6023 1.50897 -0.762137 4.81239 -9.09803 -8826 6 39.2154 11.7026 22.7855 15.1366 1.14561 24.1899 -8827 4 39.8619 11.6546 23.5153 -3.42244 7.72178 -8.31759 -8828 4 38.7922 10.855 22.8508 -11.0077 -10.6036 -7.38167 -8829 6 13.6049 36.3215 30.6697 16.8779 70.0034 -37.8159 -8830 4 13.9417 37.1302 31.1268 -10.116 -30.1168 -5.71441 -8831 4 13.4922 35.6039 31.2515 -3.36872 -19.2676 30.0327 -8832 6 50.5831 9.86782 9.34675 -39.9446 -18.2052 0.719337 -8833 4 49.679 9.5553 9.65542 27.7691 6.62521 -8.8993 -8834 4 50.7343 10.6656 9.84378 7.47556 12.1458 9.31829 -8835 6 49.6659 40.3022 22.5839 -5.95569 -23.2057 2.00246 -8836 4 49.9088 39.3695 22.3976 1.04597 17.1639 -6.42107 -8837 4 49.3089 40.2511 23.4853 9.00681 3.37443 -0.55643 -8838 6 7.21026 41.318 28.8937 -13.882 28.5523 32.2899 -8839 4 7.13277 41.6426 29.851 5.74914 -19.7174 -37.6289 -8840 4 7.14599 0.215754 28.3517 11.7183 -8.26627 3.5395 -8841 6 13.0317 18.008 25.3351 57.1177 45.3919 41.6622 -8842 4 13.702 18.0765 24.6297 -18.9881 -2.87884 -2.05071 -8843 4 13.5608 18.5052 26.1022 -41.5403 -41.2906 -37.5185 -8844 6 50.0508 19.5822 2.43378 8.05757 -12.3534 -25.4868 -8845 4 50.6415 19.2321 1.70522 -9.91294 15.3245 28.3035 -8846 4 50.4964 20.3068 2.88656 9.48594 2.0046 -2.18375 -8847 6 28.3417 40.9623 24.5247 28.1527 -9.28969 -2.11238 -8848 4 28.8808 40.6229 23.7869 -8.53201 1.00989 5.926 -8849 4 27.851 41.6822 24.1702 -24.0642 17.3603 -12.6153 -8850 6 19.4173 5.36544 29.5282 -16.7292 -1.42659 17.4998 -8851 4 20.0576 6.03033 29.2802 12.6037 1.87093 -5.71578 -8852 4 18.8017 5.84191 30.1159 0.735032 -8.12986 -7.95209 -8853 6 35.3107 40.1454 22.2712 -2.40765 19.7984 -7.699 -8854 4 35.7006 39.9699 23.1142 6.54418 -16.9762 14.0951 -8855 4 35.2702 41.1078 22.294 -0.592679 0.794763 -5.20647 -8856 6 16.1889 33.7724 9.7458 10.3229 10.2088 29.582 -8857 4 15.8959 33.2543 9.01299 -6.07516 -13.8809 -16.7379 -8858 4 15.6715 34.5759 9.82028 -7.73583 2.776 -7.11592 -8859 6 17.3675 40.6445 20.2267 0.0256395 24.2963 -9.09373 -8860 4 17.2094 39.7816 20.6122 1.5629 -5.58702 6.23448 -8861 4 17.4758 41.3298 20.9152 1.51783 -13.2527 0.49298 -8862 6 20.5171 9.72867 9.58726 35.059 7.05341 -25.1666 -8863 4 21.2226 9.96362 10.213 -13.2653 -0.810893 -5.91795 -8864 4 19.8248 9.38464 10.113 -26.7953 -13.816 19.6743 -8865 6 47.4426 20.1922 21.3765 55.2231 -18.8128 34.629 -8866 4 48.295 19.6294 21.3384 -41.3243 22.9169 -3.74061 -8867 4 46.9816 20.0754 20.5659 -14.9725 -5.50706 -31.0177 -8868 6 38.4071 40.79 37.8146 12.3234 -22.6201 -9.80787 -8869 4 38.1404 41.7017 37.8605 -3.64711 23.1989 -4.06141 -8870 4 38.2696 40.4362 38.6954 -10.1247 -0.131598 9.15413 -8871 6 4.78578 1.94641 13.1038 0.280311 5.55092 -8.42179 -8872 4 4.79931 1.2475 12.4246 2.88607 5.75183 11.0778 -8873 4 4.58324 1.57529 13.9639 -2.31824 -10.9024 4.61034 -8874 6 46.8249 29.0091 2.16845 3.76482 2.94797 40.2579 -8875 4 46.7332 29.1215 3.14399 -15.0191 0.321828 -28.5005 -8876 4 47.6691 28.5689 2.15078 10.7116 -9.65214 -17.1948 -8877 6 37.4359 26.1653 25.6478 9.30824 1.4869 -5.75173 -8878 4 37.1837 25.5346 26.3178 -5.80587 -7.25577 3.90549 -8879 4 36.6384 26.5534 25.3025 -7.59782 4.42715 -0.0787482 -8880 6 27.3269 4.19583 19.442 5.96538 17.8772 -24.7701 -8881 4 28.0114 4.58146 18.8428 -3.77368 -14.8915 15.8068 -8882 4 26.5277 4.61529 19.0816 -6.14884 -6.84507 9.70558 -8883 6 29.57 35.1706 32.6629 9.65469 -19.4491 -13.9626 -8884 4 29.5306 34.4116 32.0191 -0.1659 24.8691 21.1709 -8885 4 30.4743 35.5004 32.5856 -0.51053 -0.290213 -2.43375 -8886 6 51.6097 27.3863 34.6091 -31.2455 30.913 9.06642 -8887 4 51.929 26.6019 35 16.42 -40.5282 7.55135 -8888 4 52.0725 27.582 33.8009 7.9649 -1.59603 -13.3915 -8889 6 26.2078 15.7281 22.6941 16.538 -21.7488 31.7554 -8890 4 25.9667 16.5615 22.3191 -8.70869 23.0893 -12.8942 -8891 4 26.0629 14.9994 22.0993 -9.54979 -3.97748 -17.7982 -8892 6 36.1239 41.1986 15.4707 -7.45359 -19.8962 -4.3143 -8893 4 35.6999 40.3419 15.2987 -9.47391 11.3121 -0.409552 -8894 4 37.0386 40.9374 15.4513 15.7433 3.85103 -0.545832 -8895 6 18.465 8.81345 11.2165 5.38391 10.0618 1.17025 -8896 4 18.7987 8.15135 11.8182 8.53154 -1.35082 11.1952 -8897 4 17.7161 8.38168 10.8393 -16.7411 -2.38381 -11.2186 -8898 6 30.2088 21.3096 23.2049 -11.6688 7.62645 -9.73036 -8899 4 29.9671 22.1993 22.9248 4.97058 -0.914249 3.78278 -8900 4 29.5299 20.7541 22.7893 7.94877 -1.13118 2.47612 -8901 6 22.73 2.20521 34.8374 1.74432 -25.8699 49.3747 -8902 4 22.3572 1.29354 34.8889 6.16039 22.5731 -10.8251 -8903 4 22.7018 2.4887 33.9486 -6.75325 10.5307 -40.1895 -8904 6 12.6909 2.75059 12.3422 -14.3125 16.3183 -13.6311 -8905 4 12.533 3.61796 11.8786 11.7453 -23.2619 14.9881 -8906 4 13.1336 2.19907 11.6816 1.83842 1.45343 3.2847 -8907 6 24.107 30.0639 14.5719 -73.5796 11.8292 4.65098 -8908 4 23.699 30.7611 15.1345 32.1371 -0.343623 -0.31889 -8909 4 23.2337 29.7156 14.2286 43.085 -3.68866 -7.89372 -8910 6 0.015177 27.9048 22.8533 -2.756 -4.53229 -2.63487 -8911 4 54.6492 28.3778 23.623 -8.36257 -3.01834 -6.1652 -8912 4 54.216 27.6514 22.3224 8.23112 8.70814 10.2495 -8913 6 12.3617 4.4844 25.9108 40.9735 -25.7794 -17.3291 -8914 4 12.201 5.40791 25.8162 -22.6464 21.2272 1.21762 -8915 4 11.6198 4.00067 26.267 -15.5784 4.93476 10.9426 -8916 6 50.6578 14.4652 5.91353 -13.9437 -6.30553 43.3918 -8917 4 51.4397 15.014 5.76935 2.55266 2.90763 -3.8133 -8918 4 50.4787 14.4827 6.92851 9.15248 3.54798 -49.9389 -8919 6 52.5668 22.873 20.1428 -12.6564 -29.9263 -28.8801 -8920 4 52.956 23.3393 20.8718 4.45243 13.9606 14.107 -8921 4 52.7899 23.3428 19.3246 -0.129831 10.341 11.583 -8922 6 43.5892 16.524 12.8775 29.595 -3.78245 -19.1347 -8923 4 44.3058 16.0087 12.3806 -28.6005 27.9094 23.6723 -8924 4 42.7982 16.4888 12.3437 -11.2315 -8.54457 -10.2035 -8925 6 15.9661 16.7487 40.5866 1.44034 32.7745 -1.20572 -8926 4 16.4126 17.3388 39.9207 -12.1014 -18.8104 17.452 -8927 4 15.5985 17.3766 41.2587 12.5036 -14.614 -16.5617 -8928 6 23.4158 18.8712 23.8473 -16.0774 -11.4939 3.2157 -8929 4 23.4518 19.2692 24.728 -0.157295 3.62127 -3.85719 -8930 4 22.4941 18.9757 23.5436 12.0607 -0.266031 2.57498 -8931 6 46.4178 3.27548 31.8952 19.5415 -1.29071 -17.2416 -8932 4 45.5866 3.26999 31.4067 -8.61336 -0.166695 4.01481 -8933 4 46.2657 3.3297 32.8359 -5.35267 1.32166 2.09612 -8934 6 43.4045 41.0584 12.2875 -8.04746 -23.5947 4.76735 -8935 4 43.6693 41.8276 12.7696 6.05224 12.9314 10.8988 -8936 4 43.5172 41.2728 11.3626 0.904796 3.93503 -13.2342 -8937 6 7.4976 32.4756 29.5884 -13.7893 55.6862 -12.0377 -8938 4 8.07142 31.7837 29.8334 27.4303 -26.9633 6.13269 -8939 4 8.04212 33.3166 29.512 -13.0153 -27.2422 -1.65156 -8940 6 4.77821 31.644 22.4997 2.28771 28.4048 16.4959 -8941 4 5.27411 32.2412 23.0928 2.56389 -13.4484 -8.63656 -8942 4 4.12057 32.2584 22.1518 -1.39427 -10.0394 -7.16978 -8943 6 48.879 26.8662 2.67919 -5.86075 -60.7959 24.9619 -8944 4 49.7001 26.7095 3.23946 -26.2991 7.4186 -32.0291 -8945 4 48.3448 25.9902 2.75892 28.4546 51.6452 -6.88552 -8946 6 35.3626 23.261 21.6242 -2.7789 -2.57103 6.54281 -8947 4 36.2261 22.8974 21.81 4.94258 -15.6751 6.88864 -8948 4 35.5426 23.9136 20.9639 -1.02428 17.548 -23.8062 -8949 6 9.79934 37.7758 27.3048 16.52 16.637 17.9603 -8950 4 9.72643 38.6113 27.803 -16.1555 -8.36248 -12.7831 -8951 4 10.5885 37.4189 27.7206 -2.15823 -16.4776 -5.60851 -8952 6 6.95685 10.9812 25.9821 -25.178 -21.2877 -4.97438 -8953 4 6.33357 10.2528 25.7268 23.179 21.9129 0.503821 -8954 4 7.29095 10.6974 26.8328 9.60603 -1.481 14.6966 -8955 6 15.9965 34.4888 38.9273 -2.91878 -3.91161 19.3063 -8956 4 16.0374 33.5463 38.7461 4.95306 -0.665665 -16.4822 -8957 4 15.9715 34.4958 39.9054 -7.59103 5.72172 -22.2107 -8958 6 24.1167 17.3197 36.1615 15.3363 -47.5124 0.380375 -8959 4 24.7173 17.5753 36.8648 1.58194 5.49031 12.5141 -8960 4 24.1546 16.3101 36.2205 -9.7187 30.8811 -7.11116 -8961 6 29.9757 19.0472 5.63639 12.788 -31.6225 11.2379 -8962 4 30.1584 18.5328 6.46799 -12.7316 12.501 -21.5451 -8963 4 29.4206 19.7916 5.84051 -11.4929 16.6696 15.0892 -8964 6 41.2293 14.2018 25.873 -1.75888 28.9255 -23.3251 -8965 4 41.1078 15.0995 25.4693 3.83492 -22.0907 13.098 -8966 4 41.2654 14.3268 26.8215 3.7207 5.50516 9.94654 -8967 6 30.6006 17.7874 37.3562 -24.7598 46.8721 10.074 -8968 4 30.0173 18.4181 36.8416 23.2796 -25.9316 -1.25214 -8969 4 30.633 18.2764 38.2118 8.15578 -14.795 -8.30511 -8970 6 36.2662 35.7599 28.8527 -12.8707 -30.9202 21.2821 -8971 4 36.6718 34.9534 29.2396 -10.1595 12.442 -4.1956 -8972 4 37.0218 36.2801 28.6478 17.3511 22.2532 -11.5483 -8973 6 0.195836 37.8645 20.3851 -23.6217 6.21569 -13.9532 -8974 4 0.549498 37.2778 21.0637 4.94615 -2.95215 -2.70832 -8975 4 54.3862 37.4234 20.0075 16.4722 8.11718 6.90773 -8976 6 49.5165 39.5896 25.2714 -0.622408 -34.3922 32.9891 -8977 4 49.1772 39.7667 26.1925 10.9208 -1.11318 -32.3029 -8978 4 49.8261 38.6352 25.2806 -10.9036 35.658 1.81375 -8979 6 21.6574 10.1952 29.3538 -5.06277 -0.743802 10.2318 -8980 4 21.4664 11.1105 29.223 -3.01111 19.5458 -20.3057 -8981 4 21.662 10.2064 30.3052 9.73006 -17.7161 13.8831 -8982 6 36.4636 30.0567 0.119709 9.37859 61.6807 38.5429 -8983 4 36.3123 29.4684 41.3206 -1.21017 -23.1836 -37.505 -8984 4 36.9143 30.908 41.7057 -13.4567 -39.5067 4.20368 -8985 6 35.2344 23.3726 39.1433 31.8417 -88.9919 -51.9106 -8986 4 35.0278 23.5012 38.2069 -5.96056 -5.38998 8.96032 -8987 4 34.9909 24.127 39.538 -31.8308 96.9265 45.0865 -8988 6 25.4761 17.6258 38.7257 1.29934 8.28965 -16.1346 -8989 4 26.2031 17.0769 39.0234 13.7946 -6.33455 1.86524 -8990 4 25.7107 18.4933 39.0598 1.3782 7.33891 4.86011 -8991 6 32.6846 1.71002 15.3734 -11.6254 -20.3205 21.5399 -8992 4 32.9453 1.93093 16.3086 -8.96834 -8.53877 -20.2534 -8993 4 32.154 0.853232 15.3925 19.204 32.1949 4.36426 -8994 6 2.7574 26.2382 40.1716 -4.40087 -21.6692 -50.7652 -8995 4 2.38718 26.7949 40.8139 -8.13358 26.7101 38.7547 -8996 4 3.41358 25.6429 40.5298 13.0891 -5.49009 7.80053 -8997 6 25.4307 39.5752 6.64887 -26.4755 -1.32722 14.1102 -8998 4 25.8932 39.0809 7.30961 27.038 -6.17916 -3.25304 -8999 4 24.5458 39.4465 7.03066 -2.44587 12.932 -21.9634 -9000 6 3.88975 2.45855 21.1879 28.3389 -91.355 -25.6726 -9001 4 3.44478 1.54109 20.9736 25.4092 48.4753 9.01111 -9002 4 3.19228 2.99847 21.4284 -47.2055 43.8768 12.3888 -9003 6 19.4353 35.9908 6.17834 -1.98144 -11.1023 18.0698 -9004 4 18.7425 35.7628 6.83514 2.39623 12.5316 -16.1317 -9005 4 19.0828 36.5127 5.45195 -11.0597 11.4176 1.1294 -9006 6 53.664 10.8386 34.7899 -0.427116 -3.27611 41.7292 -9007 4 53.6105 10.6836 35.7561 -1.66612 -17.5448 -26.7849 -9008 4 53.9652 11.7272 34.8329 4.68725 29.9217 -18.2793 -9009 6 51.2799 14.0867 34.6651 -29.2798 -10.9719 -23.3019 -9010 4 50.6522 13.5411 34.1107 26.8684 18.9114 5.01949 -9011 4 50.9895 13.8814 35.5479 1.81167 -5.08277 17.6681 -9012 6 14.4338 40.0198 28.0288 -0.147098 23.5255 27.6002 -9013 4 13.7688 39.3521 27.8218 1.28331 -8.25373 7.75106 -9014 4 14.1948 40.5222 28.8704 -0.878391 -19.6822 -29.209 -9015 6 36.0552 40.8569 1.29319 48.4065 13.1893 15.2608 -9016 4 35.4421 41.0883 1.96787 -21.4185 -0.412662 13.5205 -9017 4 36.896 41.2683 1.66088 -27.5471 -12.7345 -18.5843 -9018 6 32.5846 21.8706 9.62772 14.4951 6.80277 0.680584 -9019 4 32.1936 21.3098 8.97285 -7.2875 -23.9506 -7.81502 -9020 4 32.858 22.6104 9.08324 0.955029 10.0343 1.40437 -9021 6 53.7602 11.4574 10.0748 -7.70253 -4.89045 -17.0247 -9022 4 54.6558 11.7035 10.3272 3.70339 -10.2166 -5.16833 -9023 4 53.8328 10.8374 9.31644 -2.27357 5.83713 13.9933 -9024 6 25.443 2.0669 35.0212 -16.7533 17.7231 -21.4763 -9025 4 25.6415 2.91576 34.5502 -7.64634 -16.7974 11.4347 -9026 4 24.4652 2.09352 35.1703 17.3945 -2.11295 -4.26167 -9027 6 38.4088 16.3775 27.0777 23.4896 -26.556 7.92078 -9028 4 38.4029 15.905 27.9411 -0.72651 18.7119 -5.4255 -9029 4 38.1233 17.2789 27.1678 -4.67214 15.3602 11.0072 -9030 6 11.9834 11.8283 38.0863 1.50515 -20.9897 -19.5245 -9031 4 12.337 12.445 38.7318 -5.05033 4.06408 7.46746 -9032 4 11.0493 11.6049 38.244 7.06215 11.5652 6.68382 -9033 6 21.1646 40.7247 25.8949 30.8575 -6.32012 -20.5276 -9034 4 20.7152 41.4784 25.5554 -14.4662 20.9939 -18.0031 -9035 4 20.8194 40.6451 26.758 -13.9443 -15.9826 36.5019 -9036 6 5.45737 31.2526 28.1092 12.1805 15.5126 -2.48606 -9037 4 4.77986 31.7446 27.6301 0.776808 -0.764161 -8.53258 -9038 4 6.21204 31.8695 28.2031 -7.61365 -6.18966 7.74582 -9039 6 38.5666 10.4345 26.6322 12.4833 -8.23035 1.5222 -9040 4 39.2815 10.9281 26.2104 -2.91177 1.8082 -0.00903947 -9041 4 39.0293 9.89744 27.2937 -7.88948 5.75886 -1.98766 -9042 6 34.5704 22.2441 5.77364 -5.35359 -6.12765 6.5276 -9043 4 33.6261 22.329 6.01336 10.9983 8.59631 1.2651 -9044 4 35.1361 22.6291 6.46875 -10.1328 -5.43064 -4.61746 -9045 6 19.508 23.4157 8.91293 -5.78488 4.73981 5.04963 -9046 4 19.7274 23.1974 9.83518 1.16663 -6.94775 -9.92836 -9047 4 19.9131 22.8043 8.29809 9.12387 -6.1547 2.91491 -9048 6 19.7424 39.1606 18.9462 6.36032 12.2479 8.14591 -9049 4 20.3561 39.0422 19.6872 -3.85164 -4.35394 -5.20149 -9050 4 19.0738 39.7495 19.3414 -1.06489 -8.07777 -11.9442 -9051 6 19.0057 16.6591 37.8853 37.3334 -16.7993 4.17439 -9052 4 18.1861 16.4809 37.4823 -32.8062 -2.38488 -19.1553 -9053 4 18.8146 17.2984 38.5514 -2.10283 15.4454 14.1988 -9054 6 46.1541 18.3125 34.4675 -16.9871 7.29415 15.254 -9055 4 46.1595 17.7325 33.7168 0.615393 -10.1859 -17.2384 -9056 4 45.2376 18.6499 34.5058 9.28079 -5.03019 -2.85447 -9057 6 37.6537 4.93165 10.635 20.1552 -8.04423 -16.7256 -9058 4 38.5399 5.21744 10.272 -26.6503 -7.30776 7.98139 -9059 4 37.1074 4.55852 9.88971 22.9932 21.6332 27.1334 -9060 6 51.9792 36.004 6.8478 30.791 3.18545 -0.726681 -9061 4 52.2413 36.7963 6.35992 -14.9215 -4.55469 -2.53046 -9062 4 52.8266 35.8818 7.33626 -22.3254 6.63746 5.40006 -9063 6 26.6741 12.3268 1.0034 -10.7024 -25.4666 -34.2692 -9064 4 26.4988 12.3574 1.94138 -4.81655 1.43394 14.8604 -9065 4 26.0954 11.585 0.663483 16.9242 17.5219 15.4646 -9066 6 51.3423 35.7724 13.5298 -0.266216 29.5034 10.6004 -9067 4 51.4043 36.4131 12.804 2.34884 -4.4098 -1.45811 -9068 4 51.4073 34.9167 13.1542 5.41074 -27.2154 -15.541 -9069 6 1.98873 3.64285 24.5869 25.9971 69.8048 -55.2188 -9070 4 1.65752 3.03018 25.1632 -30.3002 -46.9535 54.3289 -9071 4 1.71436 4.54846 24.8879 2.6309 -26.2008 -0.982747 -9072 6 33.5221 15.2795 16.4506 0.0536135 -15.838 -38.1617 -9073 4 33.6476 15.3964 15.4593 -8.63578 3.82522 35.1416 -9074 4 33.7341 16.1085 16.8736 8.85342 14.4801 4.37501 -9075 6 10.7227 26.5775 37.3442 -67.903 54.2831 -20.645 -9076 4 10.2191 27.0779 38.0369 14.5194 -13.2702 -3.80745 -9077 4 11.4784 26.2608 37.7268 68.0232 -30.094 41.6962 -9078 6 39.6271 8.38119 31.999 1.44949 -5.13238 35.1009 -9079 4 39.1996 8.85287 32.7464 5.61163 -5.5592 -21.3265 -9080 4 39.0885 8.45634 31.2221 -15.3514 9.3045 -12.0182 -9081 6 48.873 24.2439 11.5987 1.10357 -37.2725 -9.21005 -9082 4 49.1825 23.3167 11.4023 -5.65288 27.9965 8.32055 -9083 4 49.5986 24.6511 12.0826 3.19491 3.15896 -2.50749 -9084 6 15.8098 8.51994 22.5326 -12.5814 0.672941 2.19285 -9085 4 15.7588 8.52265 21.5683 10.3815 2.49136 4.36748 -9086 4 15.4206 9.36801 22.7863 6.5895 4.65597 -0.371293 -9087 6 16.9392 23.5364 7.95083 25.1749 21.5498 -34.0775 -9088 4 17.2079 23.9031 7.093 -25.8979 -5.01679 3.50755 -9089 4 17.8126 23.4623 8.29573 16.7216 -7.09478 32.6865 -9090 6 42.4825 26.8555 6.33102 0.60087 7.54144 -12.7632 -9091 4 41.764 27.4892 6.46083 9.75026 1.01062 3.5184 -9092 4 43.14 27.3488 5.78659 -9.42643 -3.33158 7.6404 -9093 6 36.8078 4.79995 30.0438 -4.74249 18.2042 -3.85385 -9094 4 36.952 4.89746 30.9922 3.10706 -1.8894 0.559973 -9095 4 36.294 4.02131 29.8808 -10.4691 -15.4659 3.71438 -9096 6 45.6128 11.6142 3.31163 15.5246 21.1623 13.6733 -9097 4 45.8972 10.701 3.31117 0.727629 -14.3179 7.30305 -9098 4 46.2501 12.0834 3.90994 -13.3278 -10.7206 -15.6492 -9099 6 24.8943 36.3842 21.2731 0.145584 -0.0155718 21.9832 -9100 4 24.5073 36.3627 22.1568 -5.92138 3.86098 -2.91089 -9101 4 25.79 36.6624 21.4916 7.30899 1.2523 -13.3669 -9102 6 31.8172 24.7218 2.44079 24.9542 32.077 -0.738567 -9103 4 31.5948 23.8911 2.82575 -7.26237 -24.1795 3.52598 -9104 4 32.7966 24.7848 2.51706 -20.2581 -1.29655 -5.98664 -9105 6 24.135 21.9795 37.225 -18.6422 57.7065 19.5247 -9106 4 24.1223 22.9841 37.1061 1.06209 -41.2434 9.50937 -9107 4 24.7129 21.6948 36.5371 13.1815 -12.7877 -24.1492 -9108 6 37.1979 11.5342 15.06 20.8972 -17.7328 -40.5152 -9109 4 38.0246 11.7972 15.4709 -1.33045 5.21986 19.7962 -9110 4 36.429 11.9138 15.4438 -18.178 22.6449 25.793 -9111 6 36.4751 20.3399 41.7845 -26.5497 -48.0551 41.2862 -9112 4 36.3228 19.4621 41.3748 1.60744 11.8178 -3.29004 -9113 4 36.9246 20.873 41.191 27.5593 28.4699 -43.2619 -9114 6 32.0497 37.9214 32.6612 -32.2386 -8.50634 -18.7459 -9115 4 32.4337 38.7163 32.9803 20.8647 20.5609 12.2985 -9116 4 31.3654 38.2694 32.0613 5.31663 -14.2519 5.69849 -9117 6 12.0395 39.928 22.5123 -26.9832 36.7812 23.3187 -9118 4 12.2839 40.8414 22.1926 -3.01474 -29.6796 4.86816 -9119 4 11.2932 40.0883 23.1662 29.524 -10.585 -25.0576 -9120 6 26.3406 1.33526 19.2893 15.6729 -20.8034 13.8388 -9121 4 26.8411 0.655996 19.8199 -14.5491 24.9752 -14.9066 -9122 4 26.8003 2.1813 19.3861 0.112049 0.00336314 -1.02908 -9123 6 5.91669 14.3164 5.69097 2.29729 -16.5161 -30.3395 -9124 4 6.30102 14.1024 4.7902 -6.32478 5.25084 23.5077 -9125 4 5.06552 13.8494 5.70115 7.33482 -6.30923 1.55114 -9126 6 13.3703 23.089 19.1627 -28.3895 15.3871 14.4757 -9127 4 14.1086 22.8122 18.6632 27.2898 -8.01563 -16.6587 -9128 4 13.6991 23.742 19.8005 3.67942 -13.964 0.879599 -9129 6 23.4058 15.0688 9.73621 -4.11719 1.06855 12.2005 -9130 4 22.5732 14.661 10.02 0.657405 4.9462 -7.25364 -9131 4 23.2196 15.7347 9.05868 -5.70535 0.38861 -5.0655 -9132 6 49.5812 13.8288 18.4474 0.101153 1.0527 41.008 -9133 4 48.8214 13.4814 17.9923 -8.96247 -7.71084 -15.1851 -9134 4 50.2052 14.1722 17.8367 10.7879 13.5653 -33.2962 -9135 6 41.7444 5.67096 41.8915 25.5819 0.859229 17.1787 -9136 4 42.5704 5.9364 0.475256 -21.6624 -6.74737 -14.5764 -9137 4 42.0361 4.9893 41.2645 -5.04703 6.59959 -2.77397 -9138 6 17.2492 35.5437 2.55512 -4.98919 17.2489 6.23124 -9139 4 18.1963 35.629 2.41282 7.59523 -3.20753 1.41995 -9140 4 16.9663 34.6563 2.38439 4.57262 -16.6324 -5.73806 -9141 6 49.6936 19.8647 40.242 36.1149 -8.05295 1.41344 -9142 4 49.24 19.0314 40.466 10.1916 2.45634 3.62304 -9143 4 50.6901 19.7225 40.3055 -34.6505 -2.12616 -4.55887 -9144 6 38.3055 5.83107 32.0437 -25.1209 3.13983 17.5072 -9145 4 37.8566 6.51058 32.5952 5.57321 -12.5864 -8.78808 -9146 4 39.2068 6.11217 32.0045 20.6085 6.27671 -1.8315 -9147 6 16.2656 6.85278 34.0134 13.6308 -7.44031 -0.955967 -9148 4 16.5278 6.7006 33.1016 -0.686465 1.61317 -6.98637 -9149 4 17.0706 6.57794 34.496 -11.7464 5.49098 9.02554 -9150 6 33.6779 18.1919 10.4599 39.833 -25.9405 -6.08719 -9151 4 34.2274 18.843 9.984 -7.48822 -11.4027 6.26591 -9152 4 34.2403 17.3374 10.5556 -30.6671 44.9369 -7.76686 -9153 6 38.8896 33.7563 36.7672 22.7659 10.9801 -36.8997 -9154 4 38.4264 33.5452 35.9055 8.66825 7.19978 21.2858 -9155 4 39.8358 34.0039 36.5278 -27.7603 -15.0244 3.77145 -9156 6 45.3747 13.0912 20.2115 -8.54575 18.1695 38.2532 -9157 4 45.1986 12.6554 19.3957 -4.2418 -14.8759 -23.2281 -9158 4 44.5273 13.1029 20.6991 7.89471 -4.73094 -13.0554 -9159 6 36.3919 32.2126 8.83938 1.15121 -2.28434 -1.4136 -9160 4 36.3207 31.3933 9.34391 1.93757 3.36082 7.91897 -9161 4 36.0586 32.9456 9.38554 -3.10773 -8.06217 -4.51958 -9162 6 7.93399 27.8164 6.18652 -8.84441 8.26416 -30.5327 -9163 4 8.20753 27.2416 6.88401 9.15323 -7.03573 14.7081 -9164 4 8.30192 28.6748 6.41842 -5.04409 0.971707 0.751098 -9165 6 14.2889 4.87494 33.6812 -48.074 -5.72289 -27.637 -9166 4 13.5426 5.15568 33.0467 38.2298 -5.02982 23.8683 -9167 4 14.8103 5.65434 33.8518 10.0815 16.0504 2.39638 -9168 6 12.247 8.64363 9.86387 9.5307 8.47707 -42.9656 -9169 4 12.7265 8.83196 10.6522 4.83417 -1.95201 32.3898 -9170 4 11.3733 8.28369 10.003 -7.27928 -7.56138 14.4849 -9171 6 29.7193 31.982 8.5339 -11.3757 5.45371 -22.6092 -9172 4 30.2272 31.7973 9.28681 18.5431 -1.21859 37.4341 -9173 4 29.7513 31.1489 8.05875 -9.95983 -0.182644 -6.87416 -9174 6 22.3912 10.8818 21.4749 22.6973 -30.3469 0.856054 -9175 4 21.7953 11.1177 20.7819 -19.5872 13.8984 -18.5017 -9176 4 22.3568 11.5583 22.1363 -13.7305 16.7548 8.89642 -9177 6 54.1825 27.5382 12.9949 16.0749 -34.873 29.2784 -9178 4 0.169556 27.5337 13.075 -9.84187 5.32432 -2.29215 -9179 4 53.8855 28.25 12.4714 -3.97587 36.1158 -26.3516 -9180 6 7.7322 13.8127 20.037 -51.4252 10.19 -38.2554 -9181 4 8.32211 14.101 20.6974 26.6579 16.8549 28.1402 -9182 4 7.28001 14.6396 19.6917 19.816 -24.9044 7.79538 -9183 6 19.8038 0.841082 24.7751 2.23798 25.7663 18.7115 -9184 4 19.2888 0.974936 25.5977 -1.44078 2.26272 -14.328 -9185 4 20.345 1.66892 24.688 -12.1486 -28.8133 2.35345 -9186 6 3.00622 10.0987 2.94957 -26.3714 23.4248 -9.90714 -9187 4 2.57802 10.9845 2.80681 8.85648 -28.8297 5.38 -9188 4 3.90714 10.2978 3.18407 20.8138 3.7803 5.2 -9189 6 15.8735 13.0135 24.0167 27.3456 -6.4848 -7.35342 -9190 4 15.0397 13.4574 24.067 -14.2007 12.8972 1.61729 -9191 4 16.3075 13.2711 24.8409 -0.511489 -7.63656 -0.0548578 -9192 6 17.0843 4.34635 26.9246 21.6007 -4.50946 14.2865 -9193 4 16.8972 4.2188 26.0046 2.50265 0.324122 -20.691 -9194 4 18.0611 4.2338 26.9976 -18.2314 5.96709 -0.11875 -9195 6 33.6189 39.4094 10.6341 -20.462 51.0085 -28.6484 -9196 4 33.9391 38.663 11.0702 20.9333 -51.253 8.17882 -9197 4 33.8334 39.409 9.67256 -1.15733 -4.02232 18.0774 -9198 6 36.2391 1.10544 13.1071 -14.4853 9.25302 -40.2412 -9199 4 35.5849 0.422507 13.2928 -0.138393 -8.38057 10.5121 -9200 4 36.8138 1.26142 13.8363 9.41155 -3.27129 23.8008 -9201 6 40.853 19.2974 5.10856 37.2457 -28.9827 71.4026 -9202 4 40.5429 19.587 4.3016 -40.6732 16.7295 -57.0845 -9203 4 40.1307 19.0416 5.7147 0.644924 10.2678 -10.4268 -9204 6 2.34714 37.5568 10.1845 35.9634 7.02123 17.8242 -9205 4 3.04769 37.1203 10.7322 -14.847 6.26565 -12.1612 -9206 4 1.86424 36.8893 9.71962 -14.8151 -24.6966 -11.8987 -9207 6 8.10127 29.0413 15.8656 35.302 -29.7249 12.8686 -9208 4 9.00843 28.6191 15.9508 -31.5464 15.4715 -14.0583 -9209 4 8.16404 29.7921 16.4466 -1.11054 13.1495 4.82257 -9210 6 47.3142 26.5199 12.5393 12.6514 34.6971 -22.5506 -9211 4 47.5805 27.2834 11.915 -17.373 -39.4708 28.4474 -9212 4 47.3752 25.7188 12.0092 -0.907674 -0.00416251 -5.94845 -9213 6 33.5917 17.5154 0.659811 -43.6991 -50.8046 22.4668 -9214 4 32.6165 17.4611 0.916402 33.9721 22.4374 -10.1482 -9215 4 33.8023 16.5556 0.790839 15.7196 25.0769 -8.55135 -9216 6 38.9785 15.6005 36.3846 -2.2974 -5.19358 -9.56289 -9217 4 39.1604 14.6481 36.4599 -0.972636 7.263 -3.41001 -9218 4 39.314 15.9159 35.5329 5.29716 -3.31476 -2.44888 -9219 6 34.8185 34.3512 9.36223 6.47638 -43.1481 -28.0847 -9220 4 35.4473 34.9875 9.0418 9.26483 22.2324 -9.2882 -9221 4 34.4241 34.6992 10.1221 -17.9819 29.7233 40.2724 -9222 6 44.963 2.56985 14.7807 31.4374 15.1132 5.36654 -9223 4 44.0324 2.49792 14.9225 -24.9873 -3.38313 6.1219 -9224 4 45.264 3.39221 15.2058 -8.16761 -2.00961 -7.57881 -9225 6 42.6004 38.2794 19.8329 35.0217 22.8895 -33.2683 -9226 4 42.7468 39.1886 19.4383 -9.39889 -30.5105 9.50416 -9227 4 43.174 37.7101 19.2395 -23.2435 10.9907 19.5876 -9228 6 18.6884 26.768 30.2631 -44.5574 -6.69712 -17.565 -9229 4 18.1049 26.7773 29.4546 19.8507 -1.43152 25.0232 -9230 4 19.5658 26.9377 29.9555 24.8572 5.14496 -8.76909 -9231 6 38.8622 37.7231 16.4658 -22.8479 4.5656 13.1257 -9232 4 38.7902 36.7734 16.2818 1.44729 8.74588 -1.32739 -9233 4 39.7766 37.9619 16.5567 26.2519 -3.67716 3.06508 -9234 6 49.2941 9.82087 12.5338 42.2108 35.2088 45.7943 -9235 4 48.9089 9.29765 11.888 -36.0338 -29.0733 -40.4243 -9236 4 48.6148 10.195 13.1058 -6.01968 0.395602 -5.44143 -9237 6 43.2224 7.37144 19.82 -8.13737 3.26926 23.5272 -9238 4 42.5007 7.77471 20.3735 21.5488 -7.79487 -11.5807 -9239 4 44.0862 7.49788 20.2643 -6.92785 0.102081 -4.68832 -9240 6 36.344 38.7219 4.42923 6.60518 -8.27287 -3.54737 -9241 4 36.8681 39.515 4.62823 -9.591 -1.38231 4.53716 -9242 4 35.4251 38.8858 4.67742 1.90858 4.69501 2.45497 -9243 6 27.7906 17.7903 15.1063 3.75124 -7.8529 -14.6222 -9244 4 27.6041 16.8818 14.7764 0.112743 20.8749 5.00331 -9245 4 27.89 17.7299 16.0573 -1.67078 -3.69001 6.73869 -9246 6 18.0934 3.7697 37.3166 -37.4896 -7.94699 -19.9181 -9247 4 18.6099 3.0373 36.9676 7.8944 1.98274 4.30106 -9248 4 18.6508 4.23334 37.9126 25.9725 10.5984 22.5053 -9249 6 7.70643 11.5866 6.5218 3.89219 -35.3855 26.5153 -9250 4 7.81247 12.3986 6.99593 -0.830342 19.7116 4.35361 -9251 4 7.69429 11.7375 5.59555 -1.18048 8.56411 -33.1609 -9252 6 31.493 14.3493 18.0362 -8.33789 -14.4781 24.6772 -9253 4 32.1359 14.6991 17.4236 11.1505 2.18599 -11.6706 -9254 4 31.9992 13.8221 18.6877 -1.72215 8.99473 -5.41338 -9255 6 50.3257 30.4119 8.91981 13.6638 2.66477 0.921327 -9256 4 49.6699 30.7962 8.33415 -6.09837 5.9585 -1.44957 -9257 4 50.0726 29.5063 9.09532 -3.6785 -2.74239 1.52637 -9258 6 42.1666 10.1001 12.7665 27.8846 0.568566 -7.78474 -9259 4 41.2574 9.89168 12.6212 -25.0269 -7.71108 -1.23548 -9260 4 42.2044 10.927 13.2385 -4.76175 6.29789 8.61568 -9261 6 37.7726 3.10257 32.5651 17.7286 -33.908 -11.3576 -9262 4 38.1655 3.96622 32.6549 -5.80606 19.6252 0.391082 -9263 4 36.8286 3.11418 32.7073 -14.5698 15.7581 5.48125 -9264 6 35.7529 13.1025 19.269 15.6222 -22.7979 5.95892 -9265 4 36.108 13.8438 19.7616 3.89933 6.86159 4.70877 -9266 4 36.3275 12.3403 19.5267 -16.9537 12.3267 -5.61016 -9267 6 45.5307 4.12701 21.4866 3.53751 -14.4086 10.8893 -9268 4 45.552 4.15257 20.5178 1.20389 1.85135 1.62688 -9269 4 45.7304 3.20168 21.7391 -1.66454 15.9633 -13.005 -9270 6 16.8818 1.84763 31.4809 -38.7514 34.7723 -17.791 -9271 4 16.1373 2.3559 31.0688 16.7124 -32.2776 -3.52377 -9272 4 16.9707 2.38347 32.2636 22.4894 -8.71684 18.7287 -9273 6 14.088 4.88632 23.5804 12.6338 -46.5447 -4.7054 -9274 4 13.8705 5.7909 23.7155 -14.7558 31.001 11.1078 -9275 4 13.7332 4.31383 24.2952 -4.17517 18.1368 -8.36436 -9276 6 38.3179 33.7515 12.3711 -25.6361 -5.15185 -28.4625 -9277 4 38.1256 32.9508 11.8227 6.04426 17.9062 13.2724 -9278 4 39.1779 33.654 12.756 21.0695 -5.21903 12.1581 -9279 6 35.6902 3.04562 37.6746 -3.39904 8.35156 -7.25132 -9280 4 35.0929 2.54933 38.2324 -5.1037 -10.0227 3.00486 -9281 4 35.8394 3.86187 38.1597 5.81883 9.20211 1.39187 -9282 6 31.3375 37.3986 35.3773 -3.71028 -11.6357 31.0668 -9283 4 32.2621 37.6229 35.4422 12.7398 8.80293 9.59752 -9284 4 31.1956 37.5429 34.4696 -8.56261 0.879722 -41.7472 -9285 6 52.0699 11.7425 14.0188 13.7235 -2.71131 -30.9774 -9286 4 51.8967 11.0942 13.2788 12.7756 18.36 20.3091 -9287 4 52.777 12.3878 13.7226 -29.9657 -23.6346 9.26958 -9288 6 26.3494 3.44143 41.0133 25.155 -37.875 16.6614 -9289 4 25.5593 3.94137 41.1232 -17.1598 23.2709 -17.7277 -9290 4 26.8278 3.58917 40.1822 -8.59815 12.7626 -4.44352 -9291 6 24.371 34.9599 11.1571 26.4033 32.6711 -2.50587 -9292 4 24.3639 34.5741 12.011 0.42503 -6.32387 38.1824 -9293 4 23.9976 34.2869 10.6415 -25.866 -31.4028 -29.8537 -9294 6 32.0031 7.59722 31.2247 -0.72006 7.33901 18.8157 -9295 4 32.1508 7.36357 30.327 0.345644 0.817488 -27.7554 -9296 4 31.6126 8.48818 31.2118 -2.13527 -8.40442 2.30992 -9297 6 28.7291 2.6069 0.424694 -24.9548 -1.7826 -18.2237 -9298 4 29.2265 2.34055 41.548 2.55638 3.32464 9.52498 -9299 4 27.7798 2.59721 0.142899 25.7986 3.33204 9.63582 -9300 6 42.1267 19.2107 9.86358 19.9254 -1.00598 31.807 -9301 4 42.7282 19.2504 10.675 -28.0191 -3.63038 -32.4782 -9302 4 41.4654 18.506 9.99331 2.41107 5.70909 -2.24499 -9303 6 33.0117 27.0899 8.33041 6.96541 -9.8522 -22.9567 -9304 4 33.8754 26.9804 7.88875 -4.89246 2.6856 6.68054 -9305 4 33.1889 27.2976 9.23992 7.88062 7.04275 14.0068 -9306 6 4.17016 8.31297 19.162 0.312608 -23.727 -31.8356 -9307 4 4.57057 7.90515 18.3575 7.98956 13.418 22.158 -9308 4 3.24181 8.25888 18.9046 -6.31749 7.79174 9.16769 -9309 6 20.797 29.1851 37.0682 -78.8245 -16.0462 -5.4556 -9310 4 20.936 28.2326 36.9784 16.4861 -0.723813 3.66436 -9311 4 21.5674 29.6886 37.0761 54.0195 18.5923 4.39527 -9312 6 13.113 4.99943 10.9253 0.843453 12.9862 -7.21248 -9313 4 13.3812 5.91092 11.1622 0.48683 -16.0572 0.936043 -9314 4 12.7752 5.03128 10.0238 -4.21215 6.55392 -0.64752 -9315 6 37.5015 18.1018 32.5195 21.2703 25.6519 14.9603 -9316 4 38.1786 18.7738 32.2234 -25.3038 -17.5123 8.13315 -9317 4 37.1867 18.4103 33.3985 6.70568 -0.056708 -13.7279 -9318 6 17.7491 33.2689 30.7387 4.64458 14.8517 -20.1826 -9319 4 17.8421 33.9996 30.1068 1.39741 -2.79987 6.34018 -9320 4 18.5541 33.2627 31.2599 6.50121 5.74528 2.59283 -9321 6 23.1871 32.777 9.90494 7.13269 10.4795 -4.3903 -9322 4 23.4604 31.94 10.2921 1.41378 -5.3263 0.807867 -9323 4 22.2339 32.7251 9.74224 0.938735 -0.283076 -0.953242 -9324 6 14.8916 9.36878 34.2544 -3.17606 -9.25219 -4.09189 -9325 4 15.4257 8.57154 34.1751 4.23415 -4.52565 -0.814207 -9326 4 15.1936 9.94604 33.5417 3.33837 13.7034 4.88209 -9327 6 31.123 39.3556 38.5725 10.4581 -15.7875 9.507 -9328 4 31.6408 38.6334 39.0195 -17.0405 19.4438 -10.5616 -9329 4 30.3963 38.9123 38.1137 2.26745 0.847431 0.999129 -9330 6 5.28935 34.441 28.2777 -1.85934 -10.7383 -20.8922 -9331 4 5.27738 35.3973 28.3959 -1.64374 -0.931958 4.82044 -9332 4 5.15855 34.3195 27.3212 3.56171 0.206479 13.9304 -9333 6 30.3161 21.6889 14.1169 -2.08187 28.5408 26.4102 -9334 4 30.4824 20.7856 14.3415 3.20532 -20.0191 -7.60805 -9335 4 30.3589 21.8902 13.1869 1.55029 -10.1196 -17.5522 -9336 6 23.85 39.0046 28.2977 69.4329 26.2515 4.57453 -9337 4 23.9916 39.6084 27.5499 -13.57 2.08121 2.63988 -9338 4 23.036 38.5875 28.2612 -60.5143 -23.8938 -11.8576 -9339 6 9.59742 13.5396 16.4589 33.261 19.9292 -8.86772 -9340 4 8.78625 13.0496 16.3926 -14.9619 -4.96746 -5.567 -9341 4 9.78335 13.9533 15.5888 -9.09133 -14.4247 9.50074 -9342 6 25.9705 6.17968 15.7985 42.799 -23.1477 28.9675 -9343 4 26.019 6.01901 14.8637 -2.75181 4.35539 -17.3872 -9344 4 26.7603 5.64791 16.135 -36.9143 25.7793 -10.0513 -9345 6 15.9952 33.6108 22.5498 -1.32684 21.179 0.174096 -9346 4 16.0845 34.132 21.7265 -5.08009 -17.3545 9.33233 -9347 4 16.0452 32.6693 22.2946 2.44519 21.8582 -2.86748 -9348 6 40.6954 13.5457 12.1293 -5.68603 3.79069 10.9638 -9349 4 40.3939 13.0592 11.3555 -1.07855 -14.0058 -3.54454 -9350 4 41.0539 12.9031 12.7626 -3.06611 3.62129 -5.67307 -9351 6 35.5822 40.2773 31.6862 -1.2862 -13.706 14.6905 -9352 4 36.0451 40.9783 31.2154 -1.32327 -4.34646 -14.1397 -9353 4 35.653 39.3915 31.2603 0.648621 22.1552 -3.29488 -9354 6 19.3539 17.5757 17.8527 24.8545 64.4629 -5.36553 -9355 4 19.9703 18.4106 17.9379 -31.776 -45.1138 0.798127 -9356 4 18.7059 17.8424 17.1823 2.41282 -7.28307 3.58563 -9357 6 7.95249 28.0742 10.7793 26.3782 25.043 4.49745 -9358 4 8.50313 28.8396 11.0908 -15.1612 -19.5627 1.83511 -9359 4 7.20779 28.4792 10.322 -5.34026 -2.34355 -4.06419 -9360 6 32.1473 39.5951 16.6478 -17.9563 1.55165 -8.91142 -9361 4 31.6569 40.3908 16.3404 14.2892 -12.9666 6.03874 -9362 4 31.5266 38.8716 16.4637 6.06753 4.48602 8.64925 -9363 6 35.7883 2.63292 18.1275 9.48574 -34.9606 14.0071 -9364 4 34.8666 2.32593 18.1793 13.7366 6.70894 -2.41967 -9365 4 35.7792 3.51083 17.8116 -6.62646 29.9084 -15.3578 -9366 6 14.9404 39.9496 36.887 -3.95865 -34.2615 35.0372 -9367 4 15.4649 39.4425 36.2826 11.0028 -6.45738 -16.6057 -9368 4 15.0284 40.8419 36.6608 5.56286 51.7396 -15.8162 -9369 6 18.3052 32.4025 11.469 7.68428 8.43447 19.219 -9370 4 18.6311 32.5236 12.4045 -8.3236 -1.07971 -30.5152 -9371 4 17.8613 33.2392 11.223 7.02035 -14.738 0.639166 -9372 6 14.6021 10.381 5.00501 12.904 -5.64335 9.41677 -9373 4 13.6938 10.4305 4.69945 -10.3065 0.63937 1.1744 -9374 4 14.613 10.0418 5.92181 -1.23128 6.20644 -15.3767 -9375 6 2.02771 14.3355 39.1727 -5.84559 30.0988 4.34298 -9376 4 2.70173 15.0418 39.0898 -4.78946 -14.8923 5.30178 -9377 4 1.28797 14.7602 39.6738 10.0694 -17.377 -15.1558 -9378 6 7.58332 14.1556 32.4652 3.8824 27.7869 10.7592 -9379 4 6.9433 13.665 32.9756 -4.43494 -6.18284 1.69377 -9380 4 7.54129 15.0698 32.8492 6.23928 -24.1467 -15.6449 -9381 6 6.15722 23.1341 37.6504 -34.5618 -50.1938 -2.0692 -9382 4 6.56488 23.96 37.7745 13.4151 41.4847 -0.267706 -9383 4 5.38195 23.2242 37.0516 20.9526 5.02196 8.70483 -9384 6 37.2952 22.537 4.44472 51.3933 75.9823 3.75371 -9385 4 36.5074 22.1342 4.18978 -47.7056 -22.8011 -17.3868 -9386 4 37.221 23.5361 4.21623 -3.53185 -51.7458 12.1203 -9387 6 47.1368 31.0168 5.89375 -14.3926 17.1884 -69.1718 -9388 4 46.9718 30.7968 6.77028 -10.6218 -7.91998 56.0799 -9389 4 46.2684 31.351 5.53353 23.0456 -16.9797 4.17914 -9390 6 54.8109 25.5937 34.9376 16.0179 27.3393 -6.0446 -9391 4 54.0726 25.4665 35.5517 -1.08617 7.29827 -2.61058 -9392 4 0.161491 26.54 35.0366 -21.9365 -36.0956 3.57937 -9393 6 37.1499 2.07739 4.80452 -1.94348 22.0087 -45.3652 -9394 4 36.668 2.89852 4.54683 5.06511 -19.4283 11.9563 -9395 4 37.1062 1.96831 5.73813 -4.74438 -1.19387 27.2393 -9396 6 22.5142 28.609 8.91066 14.7838 -0.767913 33.3492 -9397 4 22.9803 28.3541 9.73828 -15.565 12.7605 -7.61321 -9398 4 22.8168 27.9481 8.31925 3.93055 -13.9923 -25.0246 -9399 6 8.64284 27.1533 24.5627 -30.3364 66.7798 9.61681 -9400 4 7.68564 27.0552 24.6389 4.16714 -15.7471 -5.05425 -9401 4 9.10482 26.3676 24.4825 22.9633 -64.4218 -6.53839 -9402 6 1.14841 23.7276 2.43845 3.37143 2.75553 -28.3576 -9403 4 1.24451 23.8913 1.47114 -2.40676 3.6179 20.3541 -9404 4 0.297784 23.2877 2.48462 -2.13531 -2.42607 6.29474 -9405 6 54.3749 30.2279 27.0351 -1.87188 5.01086 -25.6864 -9406 4 54.247 29.4439 26.4851 0.283672 1.58093 2.67322 -9407 4 54.589 30.9178 26.3677 -1.31459 -2.18642 16.2549 -9408 6 0.382292 8.43516 23.9819 16.8945 -11.9539 9.7221 -9409 4 1.32445 8.60369 24.1565 -2.20413 -11.2301 -8.89161 -9410 4 54.9553 8.73001 24.7921 -9.77823 11.7559 2.768 -9411 6 16.9131 28.5848 33.3683 -2.23593 -25.3201 -21.0962 -9412 4 17.3654 28.7863 34.1955 9.02781 -2.88055 -0.915496 -9413 4 17.3951 27.8627 32.8656 -13.2947 27.9561 26.4245 -9414 6 33.6945 30.8881 0.140848 11.5734 5.16226 7.65985 -9415 4 34.5903 30.4955 0.196618 -6.50407 7.83028 -3.90982 -9416 4 33.2725 30.4522 41.313 0.902851 -8.5209 -4.03004 -9417 6 16.2572 21.5133 34.1618 -1.32279 -12.2579 -0.0768877 -9418 4 15.8666 20.7686 33.6578 14.5936 10.7995 5.0381 -9419 4 16.7742 21.1109 34.8905 -13.5083 8.43335 -11.1581 -9420 6 0.208862 17.804 35.7536 -14.601 -29.9007 -2.72034 -9421 4 54.2286 17.807 35.5323 33.4083 9.0609 14.8615 -9422 4 0.362977 16.9429 36.1939 -0.60553 13.4006 -6.21859 -9423 6 16.8205 12.2987 0.018055 22.2965 10.2312 29.8095 -9424 4 17.2696 12.8062 0.753963 -11.4311 -8.71934 -28.0399 -9425 4 16.617 11.4478 0.422257 -11.1364 1.3302 -4.58262 -9426 6 8.24969 9.53941 36.253 -15.0171 13.8578 -6.15226 -9427 4 7.92627 8.96163 36.9484 -10.0154 -4.61382 -0.313479 -9428 4 7.46687 9.9886 35.83 14.4541 -3.15884 14.1629 -9429 6 48.5699 26.7153 39.8372 -6.05787 -6.72914 15.0837 -9430 4 48.3449 26.8926 38.9385 -16.4424 3.29077 -18.6566 -9431 4 49.4571 27.0352 39.8842 23.4859 3.73228 5.76721 -9432 6 35.4844 1.07048 23.1169 11.4549 30.8088 37.1655 -9433 4 36.0158 1.76714 22.6808 -9.17201 -14.7916 0.90361 -9434 4 35.6328 1.27141 24.1103 0.373025 -19.0496 -44.6811 -9435 6 20.2784 30.6315 19.3752 23.9103 -21.6662 15.3888 -9436 4 20.3116 31.0532 20.259 -5.42732 -3.95571 -8.57186 -9437 4 20.9344 29.8759 19.4191 -22.0709 25.9102 -5.54449 -9438 6 44.3706 15.9499 1.58551 5.68582 14.4456 12.9619 -9439 4 44.3685 15.5676 2.49167 2.87795 14.7015 -16.764 -9440 4 44.6274 16.9163 1.6094 -6.5628 -31.3198 6.45039 -9441 6 53.8881 34.4681 10.5864 -33.0496 11.7448 -26.9592 -9442 4 54.422 34.2751 11.3149 32.4161 -9.35278 40.7994 -9443 4 54.2788 35.2396 10.1584 -0.0979649 -6.0993 2.73708 -9444 6 46.1388 32.8516 33.5211 5.22207 -15.0187 3.22626 -9445 4 45.9452 33.6327 33.0044 -1.75723 11.2428 -3.91525 -9446 4 47.0422 32.5752 33.2841 -5.1447 4.42718 0.252344 -9447 6 42.1248 21.9061 24.225 29.3467 -8.59285 14.1471 -9448 4 43.0897 21.6191 24.2618 -39.2895 4.06832 7.69751 -9449 4 41.7308 21.6944 25.1042 13.707 1.91177 -18.5137 -9450 6 8.13464 3.90485 11.6471 19.3767 -1.70453 -18.8264 -9451 4 7.33962 4.19894 12.0861 -8.05938 -6.79837 10.6821 -9452 4 8.35918 3.01511 11.9412 -4.68297 1.80025 9.46807 -9453 6 19.6422 41.6776 9.83213 -10.6455 12.1827 13.5714 -9454 4 18.8651 41.1405 9.66265 4.99962 -3.76564 -7.41899 -9455 4 19.3487 0.264237 10.6212 9.02518 -11.5641 -14.6522 -9456 6 42.3073 8.42404 31.6799 28.9247 6.2763 -10.2166 -9457 4 41.4386 8.38933 32.0551 -18.7028 2.48038 0.978172 -9458 4 42.5266 9.37939 31.5704 -3.99861 -19.3235 1.7837 -9459 6 26.9144 16.155 25.3557 3.37886 4.46922 -29.1574 -9460 4 26.8932 15.8089 24.4276 -4.09623 14.1183 21.5023 -9461 4 26.5944 15.4425 25.8888 -2.2842 -17.5105 15.3426 -9462 6 48.2339 6.48607 12.6213 -2.32796 -4.32122 -9.13051 -9463 4 48.9884 6.29985 12.0375 -6.36801 1.93824 2.64233 -9464 4 47.4521 6.15437 12.1363 8.14441 0.739204 7.03502 -9465 6 53.4551 41.5313 30.6545 -6.55363 -20.9747 -16.7061 -9466 4 53.9707 41.8328 29.895 1.38615 3.54438 2.31965 -9467 4 53.5938 0.199493 31.3858 11.9182 14.0856 15.8016 -9468 6 47.0766 22.4304 31.8083 3.49024 11.2606 -9.33253 -9469 4 47.8957 22.458 31.249 -27.0486 7.80914 13.6686 -9470 4 46.5597 23.2507 31.6033 14.3992 -20.3875 6.89099 -9471 6 19.5103 5.43818 15.252 80.4346 7.77941 -36.259 -9472 4 19.9845 4.58151 15.2093 -6.94904 10.3389 3.32724 -9473 4 18.6939 5.26573 15.6196 -64.0069 -9.45641 27.6942 -9474 6 14.6723 30.2358 33.3977 29.3194 14.0021 -15.573 -9475 4 15.2147 30.9127 32.9173 -16.9191 -15.4944 5.99358 -9476 4 15.2716 29.4658 33.3729 -9.39086 7.05787 2.01807 -9477 6 28.44 24.2314 10.4028 3.15123 -12.4056 -9.54268 -9478 4 29.226 24.4262 10.8786 32.4584 2.85658 2.79411 -9479 4 27.8296 24.5485 11.0342 -36.3144 6.15546 12.0187 -9480 6 5.27118 14.4387 24.4945 35.1445 25.2092 -0.0633509 -9481 4 4.43594 14.1516 24.7736 -48.8682 -19.2375 4.52664 -9482 4 5.4685 14.0235 23.6561 -3.04719 -11.4521 -9.99341 -9483 6 26.3524 19.2908 19.1818 20.1263 -20.0506 -24.4735 -9484 4 26.6388 20.1349 19.5116 -1.98461 18.5008 5.62334 -9485 4 27.0961 18.9592 18.5977 -26.1102 9.18548 27.2368 -9486 6 28.5758 7.44193 13.1857 16.8206 36.5977 2.40675 -9487 4 28.4276 6.5743 12.8854 -8.83608 -34.241 -6.14436 -9488 4 29.1296 7.84613 12.4994 -7.23682 2.38597 3.89632 -9489 6 5.36882 27.1473 37.046 11.8823 -4.88323 19.1587 -9490 4 6.08575 26.9595 37.7076 -19.1456 -1.45009 -21.6041 -9491 4 5.36685 28.0942 36.8598 5.86896 -0.355799 -4.60773 -9492 6 53.1378 13.4025 16.0996 34.2435 -3.86055 5.06914 -9493 4 54.0829 13.0966 15.9504 -32.0077 5.91706 2.7318 -9494 4 52.5847 12.6783 16.4422 5.4814 -0.344951 -11.4066 -9495 6 45.452 1.01889 24.6154 3.31322 11.7394 9.54943 -9496 4 44.8157 0.989703 23.8982 -3.33354 -4.25493 -1.52857 -9497 4 44.9019 0.844105 25.4008 9.82267 -2.51687 -6.81685 -9498 6 50.1641 2.37547 13.9256 -5.79196 7.9049 4.59273 -9499 4 50.7992 2.78767 13.3238 -3.84891 -0.754592 0.637936 -9500 4 49.4746 3.0334 14.0873 2.34893 4.7321 -2.13859 -9501 6 19.5803 31.0161 39.1628 -18.0613 -25.9328 -11.5794 -9502 4 19.7424 30.2951 38.4816 -0.347779 24.7736 22.083 -9503 4 18.6224 30.9377 39.4182 28.2801 4.19594 -11.375 -9504 6 19.2561 14.7051 10.8744 35.9018 -50.5273 5.13524 -9505 4 20.0412 14.097 10.5737 -45.0165 49.548 5.48727 -9506 4 18.7602 14.0269 11.3662 -4.16951 16.5755 -2.6658 -9507 6 4.45594 39.5485 20.1375 -7.26247 21.8372 28.3356 -9508 4 3.95576 40.4005 20.2782 15.6699 -22.2203 -5.74536 -9509 4 4.87483 39.3065 21.0019 -15.4768 4.14169 -24.4646 -9510 6 29.0152 13.3442 23.91 8.01267 35.4951 15.4816 -9511 4 28.7225 12.4574 23.7464 -4.82052 -12.6612 5.31893 -9512 4 28.8407 13.5397 24.8723 9.679 -4.85246 -32.6651 -9513 6 17.068 2.76349 17.6602 17.5731 -10.7754 -19.6116 -9514 4 16.9152 3.43747 16.9733 0.569879 -2.90947 3.06519 -9515 4 17.8166 2.20316 17.3149 -21.6663 12.1671 7.12297 -9516 6 43.4725 18.0406 17.7144 -1.44781 -24.3706 15.3127 -9517 4 43.4291 17.0524 17.7495 6.1749 24.1268 -14.107 -9518 4 43.576 18.2305 18.6573 0.474252 7.4982 -2.94392 -9519 6 25.7765 40.7491 1.25834 -5.13784 -8.67992 -41.8469 -9520 4 26.3241 41.1434 1.92597 2.9618 17.1891 5.50682 -9521 4 25.7331 41.3641 0.469204 -4.81559 -13.5206 29.0343 -9522 6 0.465549 22.8917 6.22214 -2.55797 -7.94984 -3.9446 -9523 4 0.971697 22.1453 5.8424 -8.20264 3.34524 4.91565 -9524 4 1.09943 23.372 6.75946 4.60597 5.6548 -4.31438 -9525 6 26.241 35.011 18.6432 -1.36099 17.7753 -9.20742 -9526 4 25.9471 35.9461 18.6768 6.76043 -15.7179 -8.96745 -9527 4 25.6107 34.5957 19.2286 4.79325 -10.2415 3.05652 -9528 6 16.134 31.8742 7.55305 63.3701 -24.5537 -22.1036 -9529 4 16.96 31.3344 7.22221 -43.8871 18.402 28.1533 -9530 4 16.2567 32.6659 7.02685 -6.92396 6.43503 -6.66113 -9531 6 22.9365 16.8424 28.5556 -11.8911 28.7995 -6.03551 -9532 4 23.1131 16.1224 27.957 -2.92592 -13.6094 -7.1053 -9533 4 22.1672 17.3806 28.2048 22.5292 -24.3034 15.5849 -9534 6 48.8154 29.3426 32.1508 17.6607 -5.63259 25.101 -9535 4 47.9338 29.1776 31.8283 -15.752 -0.354552 -3.67809 -9536 4 48.876 28.9209 33.0523 -3.3832 13.4569 -22.7771 -9537 6 13.1275 24.861 5.55911 -24.9858 12.0714 -24.023 -9538 4 12.9095 24.1076 4.98414 3.68764 2.77663 3.09454 -9539 4 12.4428 25.5491 5.3163 19.4298 -17.0083 16.84 -9540 6 10.97 20.7168 15.838 25.2219 -21.2413 -18.4662 -9541 4 10.9273 20.4774 14.8836 -9.78471 10.8905 20.232 -9542 4 11.8407 20.3068 16.0784 -25.4832 11.5027 -0.03881 -9543 6 13.8668 18.3675 6.9377 -17.1805 34.1284 -15.5183 -9544 4 13.9861 19.3268 7.07801 0.95534 -8.68107 -9.41428 -9545 4 14.2312 17.9937 7.71618 14.696 -22.4056 21.3209 -9546 6 13.8328 12.9436 30.6366 23.8936 8.4875 1.93436 -9547 4 14.0561 12.5213 29.7889 -15.7862 -10.4805 9.2002 -9548 4 13.0857 12.5134 31.0734 -5.46762 -5.09599 -12.1481 -9549 6 17.1276 6.33232 31.2677 66.6528 76.8842 26.6004 -9550 4 16.7194 7.19542 31.0916 2.25558 -4.54354 -1.53399 -9551 4 16.4872 5.75051 31.0533 -74.7845 -70.3194 -26.0669 -9552 6 7.63688 23.4278 20.549 2.87884 3.81634 -6.68902 -9553 4 7.34623 23.1229 19.6666 2.94756 -0.449201 10.6329 -9554 4 8.04096 24.3016 20.3852 -3.87648 -11.4978 -1.95405 -9555 6 15.5875 36.6622 25.6317 44.8659 35.0544 -6.16252 -9556 4 16.5723 36.6215 25.7443 -25.3852 -14.6967 7.558 -9557 4 15.5456 37.5452 25.2115 -8.92727 -11.7797 -1.50769 -9558 6 0.738994 10.4213 22.1809 -27.1543 -36.2471 -13.1925 -9559 4 0.031346 10.3136 21.4752 22.4259 7.4169 21.1377 -9560 4 0.614162 9.62536 22.7539 0.837437 23.266 -16.3015 -9561 6 33.4753 17.3986 33.5966 50.0322 34.9653 -25.691 -9562 4 33.729 18.3684 33.3861 -23.79 -42.9591 12.1009 -9563 4 34.1104 16.8695 33.0603 -9.99519 5.32569 13.787 -9564 6 21.6594 19.0069 20.7632 22.9673 -17.6764 -6.78691 -9565 4 22.3468 19.6741 20.9606 -3.94962 -13.1079 -1.95693 -9566 4 22.1476 18.14 20.6003 -16.6978 33.0759 6.74927 -9567 6 41.7633 20.003 16.8748 -11.326 -1.31128 -8.84591 -9568 4 42.2034 19.1563 16.9874 6.48398 -7.2756 0.328325 -9569 4 41.4682 20.0367 15.9399 8.87316 5.12137 10.7952 -9570 6 12.0358 14.9766 17.6999 -26.21 -7.2152 -26.0517 -9571 4 11.2991 14.5498 17.1995 11.2858 13.8526 14.1879 -9572 4 12.4764 14.2447 18.105 9.10187 -13.3837 13.9354 -9573 6 23.0147 11.4211 40.7142 -19.9953 11.3897 74.5259 -9574 4 22.9359 12.2968 41.1901 4.60696 -23.5555 -21.1396 -9575 4 23.3157 11.5565 39.857 19.7433 14.0142 -51.5111 -9576 6 21.0056 28.3023 24.5803 -69.1041 85.2373 -40.9106 -9577 4 20.265 28.1264 25.1705 5.37048 -3.26467 3.49678 -9578 4 21.6928 27.7549 24.7451 59.1792 -66.0576 27.8401 -9579 6 19.39 13.7159 31.9239 29.4118 -13.0288 15.1298 -9580 4 18.7661 13.9847 31.2678 -13.3276 3.02657 -9.68553 -9581 4 18.8827 13.5849 32.728 -3.24577 4.6437 7.00982 -9582 6 21.5915 2.84466 24.7134 0.208747 24.5944 -29.04 -9583 4 21.6872 3.18692 23.7998 -4.92058 -5.74628 13.5023 -9584 4 22.4885 2.58061 24.905 3.18231 -12.543 15.1704 -9585 6 11.3458 29.9955 18.8336 12.03 22.8495 18.6886 -9586 4 10.5716 30.5896 18.8018 6.29595 -15.7791 -4.99952 -9587 4 11.9743 30.476 19.4324 -17.0963 -23.9187 -22.0967 -9588 6 14.6495 22.3648 8.3568 42.8177 1.00499 7.23029 -9589 4 14.0031 23.0587 8.53935 2.83958 6.20927 5.13977 -9590 4 15.5993 22.7606 8.33857 -60.0645 -13.0658 0.526795 -9591 6 43.9468 23.6541 17.2812 -2.43742 26.8438 -12.7514 -9592 4 44.7651 23.2701 16.9945 19.1668 -3.91001 -9.18188 -9593 4 43.5028 22.9 17.6346 -11.2125 -8.13016 15.2757 -9594 6 28.0047 25.4978 27.5091 9.49546 -35.4414 -7.32855 -9595 4 27.536 26.3032 27.53 -22.6173 33.7003 2.08289 -9596 4 28.9082 25.7508 27.3241 10.2254 5.98924 0.98151 -9597 6 19.1021 26.8113 33.1456 6.96794 1.44941 -44.6281 -9598 4 19.0009 26.3889 32.2316 6.61058 22.4795 36.193 -9599 4 19.4537 27.7357 32.9996 -8.5054 -25.835 6.12407 -9600 6 6.37601 19.3499 5.67113 -3.07724 -15.511 8.20386 -9601 4 6.68786 20.0294 5.07731 7.18653 8.65774 -7.7972 -9602 4 5.56195 19.7092 6.03854 -2.87224 2.62267 4.46635 -9603 6 37.49 28.403 9.68405 -10.2736 -31.6176 -26.4717 -9604 4 37.8518 27.9475 10.4351 5.1765 10.0485 19.5132 -9605 4 37.3493 27.6251 9.09625 -2.69325 25.3221 7.01666 -9606 6 17.6998 27.0953 11.7898 -36.7906 -34.4972 13.5582 -9607 4 17.0141 26.488 11.3694 25.6316 27.0728 3.78529 -9608 4 17.4298 27.07 12.7376 6.94557 14.4563 -18.9236 -9609 6 12.8888 1.93962 24.1529 -50.3802 38.9184 -15.728 -9610 4 12.0235 2.45928 24.1313 32.0413 -19.6529 -17.3906 -9611 4 12.9222 1.7892 25.0724 13.055 -19.4335 33.1456 -9612 6 27.8476 37.1183 33.3015 17.2618 -5.56645 -20.6455 -9613 4 27.8725 37.7306 32.5366 -3.66202 -8.07766 15.1749 -9614 4 28.4268 36.3488 33.0405 -13.8477 22.6944 8.61763 -9615 6 18.6736 12.3707 6.31908 6.91225 -31.4632 27.4828 -9616 4 18.6995 11.385 6.25383 -9.67628 20.7874 -2.26223 -9617 4 18.5836 12.6888 5.4344 -4.12511 6.2973 -26.1687 -9618 6 10.1784 29.305 24.7735 -9.10204 -23.9111 21.4033 -9619 4 10.6991 28.9855 25.5395 2.35147 16.2142 -6.30056 -9620 4 9.48939 28.598 24.7147 15.6456 22.7499 -9.47694 -9621 6 7.25796 3.28933 16.2737 -3.06701 21.6066 -7.53298 -9622 4 7.8017 4.02386 16.6541 -5.18893 -18.6288 5.77884 -9623 4 6.83195 2.7267 16.9458 19.6595 6.39335 -0.783342 -9624 6 32.1965 37.5589 1.11244 17.7564 -13.393 -49.4834 -9625 4 31.8113 36.9118 1.6863 -14.8068 -2.94474 23.9511 -9626 4 32.3136 38.4192 1.49585 -8.3749 16.0852 25.1081 -9627 6 10.4319 10.1504 6.4166 -7.63199 8.14139 10.6713 -9628 4 9.50403 10.3698 6.52583 -9.38347 6.87647 -8.77798 -9629 4 10.8186 10.5343 7.22249 5.92406 -9.68277 -8.25616 -9630 6 16.1813 23.2506 37.3799 25.1097 11.6639 -4.85114 -9631 4 16.5396 23.4181 38.2693 -7.5274 5.30939 -3.10176 -9632 4 16.7237 23.8262 36.781 -18.6662 -9.83464 11.0165 -9633 6 24.0859 14.3313 36.5421 -9.86516 7.30801 -0.382215 -9634 4 25.0278 14.1902 36.5644 12.4097 -8.07045 3.76472 -9635 4 23.7255 13.9571 37.3615 2.98939 6.5027 1.55174 -9636 6 27.4763 18.5532 28.7891 -13.5271 -4.91773 7.22809 -9637 4 27.279 18.1935 29.6763 -0.617381 3.48163 -16.8994 -9638 4 26.6639 18.4733 28.2428 3.34183 3.33207 10.806 -9639 6 51.5601 10.4909 1.56577 -57.9967 -14.5533 -18.7957 -9640 4 50.8004 9.99697 1.98849 19.2905 21.9947 -18.6033 -9641 4 52.233 10.462 2.20044 35.6887 -2.31897 35.1783 -9642 6 31.1159 39.6224 27.5035 10.1927 26.9633 6.19817 -9643 4 30.6636 39.3812 28.2975 -12.6206 -22.2416 8.82104 -9644 4 31.2642 40.5609 27.7597 6.49383 -23.2522 -24.0775 -9645 6 6.91312 35.9708 14.3252 -31.0555 -15.8542 22.3873 -9646 4 7.60399 36.2341 13.7609 26.7748 16.1612 -20.4248 -9647 4 7.14109 35.0698 14.5861 -2.88708 -0.858877 1.78829 -9648 6 45.5543 7.568 29.1737 -25.5302 -4.16762 -2.13202 -9649 4 44.8976 7.53234 28.4293 19.2773 0.699039 20.3251 -9650 4 45.0852 7.16669 29.9393 6.23602 2.26061 -10.7804 -9651 6 31.3622 20.562 31.6184 9.65463 4.63597 0.319717 -9652 4 31.8498 21.4034 31.7895 1.14978 -23.5084 -11.6884 -9653 4 31.8627 19.9392 31.0494 0.180852 16.2895 10.8054 -9654 6 43.0328 31.1512 10.3804 -22.1718 15.2565 33.5805 -9655 4 42.075 30.8844 10.4741 26.7443 4.92622 -3.29861 -9656 4 43.2631 31.5811 11.2548 -4.68507 -19.1463 -31.4268 -9657 6 50.935 25.5526 12.6381 -53.0362 -11.2381 37.5759 -9658 4 50.8444 26.3707 12.1889 6.26198 32.0523 -21.5557 -9659 4 51.7606 25.1556 12.4927 46.8244 -9.35474 -8.90879 -9660 6 29.329 2.97736 3.64421 22.5456 -43.1143 -6.52899 -9661 4 29.5843 3.84773 3.82541 15.3974 46.6652 11.4603 -9662 4 28.3975 3.01514 3.57252 -35.3193 1.84796 -10.7817 -9663 6 53.9306 32.0952 20.3602 -26.044 3.42844 6.98601 -9664 4 54.8587 32.2554 20.2589 13.6369 -3.90514 -8.57062 -9665 4 53.586 31.7345 19.5218 3.48091 2.50952 8.05406 -9666 6 41.7156 29.5544 6.48768 19.5894 27.0766 -19.1548 -9667 4 40.8143 29.536 6.19581 -21.1406 0.0261655 0.681639 -9668 4 42.121 30.2839 5.93213 -7.9284 -21.0777 21.5612 -9669 6 37.8354 24.5725 39.3073 -0.786614 -2.83003 -8.48557 -9670 4 37.3057 24.1981 38.5867 -0.305281 2.91934 11.1175 -9671 4 37.4479 24.2715 40.1417 -1.64355 1.86967 -5.36783 -9672 6 46.558 27.5785 23.289 -39.9634 -64.6481 11.0379 -9673 4 46.4646 27.3918 24.2576 6.74558 16.0433 -18.2165 -9674 4 45.9199 26.8188 22.9475 37.5572 46.869 6.09964 -9675 6 9.22773 27.2022 8.33468 -36.26 12.7871 28.7267 -9676 4 8.91275 27.6129 9.1801 5.62558 -9.89589 -23.2096 -9677 4 10.1414 27.0456 8.46037 35.2783 -3.07459 2.5747 -9678 6 36.0491 34.1608 13.9867 7.26402 -14.0442 8.68546 -9679 4 35.9913 33.1738 14.0461 -7.39622 22.1346 -4.41017 -9680 4 36.7548 34.3393 13.3524 -0.0889916 -4.95725 -2.25698 -9681 6 51.6742 14.4867 12.321 25.1613 25.5512 -24.4042 -9682 4 52.0989 14.4284 11.4335 -6.19684 -3.38259 22.4379 -9683 4 51.9807 15.3554 12.6493 -12.3863 -19.4348 1.31199 -9684 6 15.2583 19.6409 32.4144 29.0083 -20.2623 -33.8133 -9685 4 15.2558 19.2688 31.4922 3.04968 7.12699 22.6875 -9686 4 14.3622 19.8256 32.5802 -41.1763 4.86179 8.56209 -9687 6 27.6812 24.6569 38.3606 -19.0318 -31.8029 -32.3422 -9688 4 27.9736 25.1472 39.0974 14.6808 26.4307 29.745 -9689 4 28.3717 24.6185 37.6939 9.13491 6.22605 4.36089 -9690 6 37.5205 9.26898 13.6241 11.458 -4.07639 -2.41324 -9691 4 37.986 8.73412 14.2818 -4.17908 -1.66932 4.91722 -9692 4 37.422 10.1332 14.0472 -5.80925 -1.58022 -1.38856 -9693 6 20.8962 33.2419 26.2614 5.37543 12.855 -2.41316 -9694 4 21.3204 33.4412 27.1125 -5.30181 -3.15861 -4.46659 -9695 4 20.9369 32.3076 26.1263 8.87353 -20.0108 1.20924 -9696 6 6.59104 13.9455 35.2329 -26.8274 -4.60486 4.58094 -9697 4 6.38745 12.9897 35.2457 11.7642 5.99643 -3.17645 -9698 4 7.53507 14.0926 35.2395 12.5421 -8.77428 2.26249 -9699 6 10.0726 7.48467 6.8792 2.12641 6.95589 -11.9404 -9700 4 9.21804 7.15917 6.5645 -4.80657 -1.75614 5.47812 -9701 4 10.1222 8.42177 6.5916 5.16955 -15.159 7.51812 -9702 6 31.1977 5.95154 11.4339 24.7603 28.3677 15.6689 -9703 4 31.4296 6.16733 12.4018 -4.97657 -8.97631 -41.3224 -9704 4 31.9131 6.32779 10.8565 -11.9651 -11.6794 24.5691 -9705 6 12.1328 3.85103 35.2933 -10.0815 -12.0493 27.5499 -9706 4 12.7851 4.21657 34.7189 20.4312 8.87509 -12.0205 -9707 4 12.5123 3.89786 36.1903 -2.36263 6.36147 -16.6701 -9708 6 5.35168 6.07805 27.6549 3.96089 -18.0524 46.6648 -9709 4 5.01336 6.85569 28.0965 2.16186 8.49085 15.9688 -9710 4 5.1377 6.25223 26.7855 -7.5711 11.2001 -66.4514 -9711 6 13.1382 33.574 1.68419 20.6109 34.6607 2.95503 -9712 4 12.5953 33.0967 1.0817 -13.6453 -8.09858 -18.4215 -9713 4 13.3822 34.4502 1.26439 -11.0211 -27.5174 16.1165 -9714 6 44.6427 10.3996 29.0359 8.91116 23.4714 -13.18 -9715 4 44.4953 9.45294 29.0952 0.434286 -4.87704 -7.20081 -9716 4 44.1618 10.7755 28.2587 -0.00111917 -13.6507 16.636 -9717 6 9.15295 24.5944 6.37753 4.35763 15.0755 22.3214 -9718 4 8.87327 24.2546 5.53613 0.42871 5.14079 -20.2862 -9719 4 9.64462 25.4438 6.24707 -3.48643 -17.4971 -5.55606 -9720 6 52.5676 27.2719 21.6547 -2.39965 -30.061 -11.5856 -9721 4 52.5233 26.307 21.7841 0.332471 11.3908 13.792 -9722 4 52.7558 27.2791 20.7178 5.02488 16.4903 -8.77251 -9723 6 7.3066 16.9604 33.5537 -1.04195 2.49046 -7.43677 -9724 4 7.33543 17.7138 32.943 1.81348 -0.803559 0.920864 -9725 4 6.38938 16.6816 33.595 -7.62852 -0.129201 -7.36731 -9726 6 43.922 25.2186 7.97522 -0.776236 -10.551 19.3716 -9727 4 43.2647 24.8119 8.58447 10.2741 2.86697 -16.6436 -9728 4 43.4353 25.9147 7.53069 -5.46224 6.25576 -5.43654 -9729 6 2.0869 27.1165 13.6049 -6.62274 17.6596 -9.16822 -9730 4 2.19606 26.2295 13.9488 0.235583 -10.4047 3.43352 -9731 4 2.56841 27.1544 12.7597 2.10867 -4.70259 8.20201 -9732 6 37.3318 18.2771 2.1863 -11.4974 3.81579 3.71073 -9733 4 37.5653 17.6745 1.47223 -1.7687 -9.97531 1.83125 -9734 4 36.746 18.9091 1.7765 -5.93566 5.03593 -3.95155 -9735 6 24.9999 10.057 0.434977 -12.0635 -2.74649 0.799886 -9736 4 24.3308 10.4048 41.7106 3.78591 -9.33137 12.164 -9737 4 24.5954 9.37599 1.02184 5.69483 17.6459 -16.041 -ITEM: TIMESTEP -10 -ITEM: NUMBER OF ATOMS -9737 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 5.4990000000000002e+01 -0.0000000000000000e+00 4.1909999999999997e+01 -0.0000000000000000e+00 4.1909999999999997e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 9.97007 5.59928 0.0158605 6.82717 25.1566 0.173859 -2 2 9.62356 5.56404 40.5109 2.42388 15.8202 -17.9785 -3 2 8.17494 6.05177 40.4142 55.7411 37.9916 -4.02595 -4 3 7.24177 5.30408 40.552 -31.6102 -16.3698 1.50252 -5 4 9.18703 5.26911 0.576869 6.09491 -0.0281501 2.37507 -6 4 10.258 6.55078 0.333037 -13.6694 -25.1619 -9.93433 -7 4 10.7495 5.00053 0.227298 4.73684 -5.2578 1.97242 -8 4 10.3453 6.24708 39.9044 -16.4644 -11.4072 20.4818 -9 2 9.76873 4.13927 39.9675 -11.4588 -40.6165 34.779 -10 2 9.50273 3.78744 38.4932 15.666 28.6261 8.68394 -11 5 10.1133 2.12508 38.0108 0.295651 13.5297 3.11239 -12 2 9.21855 1.10832 39.2168 14.7368 7.58368 -1.20954 -13 4 9.08721 3.4839 40.6484 10.5431 15.7462 -21.5186 -14 4 10.7894 3.80905 40.2705 3.27862 -1.66199 -9.78219 -15 4 9.96352 4.6291 37.9056 6.4614 -19.967 -0.497951 -16 4 8.45197 3.92389 38.2658 -20.9649 -8.28542 -1.62155 -17 4 9.45855 1.42591 40.2577 0.123087 -4.74543 -3.47868 -18 4 9.48787 0.0601841 39.0477 5.23249 -11.9374 1.58081 -19 4 8.1518 1.18086 39.043 -21.148 5.31153 -2.14239 -20 1 8.09229 7.41048 40.3029 -14.2332 10.7223 -5.89196 -21 2 6.79937 8.10304 40.1889 5.24089 -19.8495 27.4218 -22 2 6.18195 7.49232 38.9365 0.114954 6.75236 -38.7125 -23 3 6.7427 7.67352 37.8124 -12.8129 -5.94191 21.2876 -24 4 8.91546 8.03754 40.1502 -4.33809 -15.705 2.93584 -25 4 6.18636 7.83053 41.1247 8.71228 4.86543 -21.2479 -26 2 7.05427 9.64124 40.1755 -39.1485 4.05492 14.7867 -27 2 5.78354 10.5475 40.1236 1.30256 17.7056 10.1762 -28 2 4.88546 10.5193 38.8862 -3.79578 -25.0164 33.8013 -29 3 5.09523 11.2746 37.9701 4.75276 20.2207 -26.2166 -30 1 3.8145 9.69296 38.9578 -10.6259 3.8922 -22.0733 -31 4 7.59986 9.93872 39.279 22.1314 0.316188 -7.87442 -32 4 7.59095 9.90263 41.1476 2.09094 2.02455 -19.3111 -33 4 6.10317 11.6308 40.2015 3.5236 -15.0099 -9.27626 -34 4 5.16114 10.4864 41.0336 -3.30627 -13.4665 3.57605 -35 4 3.54863 9.07856 39.7488 8.69916 3.95403 -0.745788 -36 4 3.18874 9.68238 38.1158 12.5738 1.24403 17.0425 -37 1 5.02604 6.79083 39.0278 7.4524 -0.797845 -45.9123 -38 2 4.17847 6.29332 37.9221 -3.7942 -15.2224 -3.95324 -39 2 2.69747 6.67222 38.2029 32.4064 16.6491 21.8024 -40 3 2.47317 7.27763 39.2627 -13.9875 -5.03172 -5.20453 -41 4 4.49693 6.75941 39.8611 -16.5463 3.77927 46.4214 -42 4 4.45927 6.7815 36.9606 1.68834 7.22657 1.16434 -43 2 4.32357 4.73766 37.6872 -14.444 16.6417 -7.09057 -44 2 3.62009 3.87951 38.7772 14.6644 -34.8859 1.43809 -45 2 5.79989 4.34797 37.5209 14.6689 -37.6664 -23.8861 -46 2 3.73665 2.34984 38.4383 -15.0607 27.3941 -9.62179 -47 4 3.8042 4.58537 36.6865 5.44811 -8.07725 9.84866 -48 4 2.54132 4.09064 38.8487 -7.82462 7.38089 1.0406 -49 4 4.05844 4.00808 39.8052 -1.99007 7.91776 -7.51683 -50 4 6.34139 4.39198 38.494 2.7915 9.59572 -3.8015 -51 4 6.26587 4.94741 36.6895 -0.816692 -0.0793993 15.4171 -52 4 5.96503 3.2496 37.1567 -11.5696 29.092 9.48874 -53 4 3.39623 2.18998 37.357 4.41378 -5.40883 18.8177 -54 4 3.12239 1.76276 39.1489 -5.35757 -4.6989 -2.16583 -55 4 4.76682 2.00075 38.5743 10.6291 -5.64517 -2.52342 -56 1 1.71265 6.3536 37.3575 -33.5913 -12.5481 -9.77554 -57 2 0.284755 6.62158 37.6816 12.6554 33.7668 -4.20076 -58 2 54.3822 5.43344 37.3699 -27.7691 3.87457 8.29319 -59 3 54.7838 4.49252 36.6867 3.01204 -3.04336 -3.37779 -60 4 1.82497 5.72672 36.5372 4.10411 3.68048 5.38879 -61 4 0.194803 6.88576 38.7694 2.48378 -12.979 2.09758 -62 2 54.7189 7.90551 36.9466 -7.72609 -12.13 5.61678 -63 2 0.656639 9.069 36.6919 -2.01357 8.03554 13.9604 -64 2 1.52683 9.2194 35.5966 7.55435 5.75852 -14.6577 -65 2 0.515029 10.1503 37.577 28.0972 23.5099 -14.6501 -66 2 2.25128 10.4257 35.3726 -4.96866 -39.5758 -10.6477 -67 2 1.27413 11.3326 37.3973 2.53894 16.486 1.64204 -68 2 2.1477 11.4375 36.2812 10.2448 65.1187 39.3263 -69 4 53.8018 8.25583 37.5371 13.1335 -2.90056 -11.9634 -70 4 54.3208 7.62968 35.9579 -2.73912 -6.0948 -8.85904 -71 4 1.62786 8.40831 34.848 -1.08621 1.70246 3.68663 -72 4 54.8519 10.113 38.4282 -15.3846 -1.92761 17.9785 -73 4 2.932 10.5406 34.5118 -0.192368 -3.19302 0.526177 -74 4 1.1987 12.2443 38.1226 0.692592 -32.2473 -20.0357 -75 4 2.79857 12.4271 36.2097 -23.9561 -41.0367 -3.09354 -76 1 53.0712 5.5328 37.7893 -5.57771 32.7805 23.2413 -77 2 51.973 4.62909 37.5111 5.69369 -27.8287 -42.174 -78 2 50.7933 5.44178 36.9635 6.83138 2.9595 14.8019 -79 3 50.2601 6.28483 37.7029 -2.00888 -3.43203 -15.9694 -80 4 52.7232 6.34215 38.4237 19.8206 -30.3225 -23.0649 -81 4 52.294 3.8899 36.6472 -5.7065 17.91 27.0613 -82 2 51.558 3.79481 38.7755 -4.51595 7.33433 1.21121 -83 2 50.3828 2.83682 38.5018 -9.13901 -44.4412 -29.5986 -84 2 52.8166 3.00155 39.2294 -15.7012 -7.04664 11.9409 -85 4 51.1774 4.47766 39.5861 12.1653 -0.853429 -2.8896 -86 4 50.5215 2.15128 37.5875 8.57056 17.9281 16.1392 -87 4 49.4053 3.30815 38.2892 0.50336 12.9055 3.57196 -88 4 50.1645 2.10956 39.3273 7.20165 10.7054 2.61524 -89 4 53.3305 3.56036 40.0335 2.85201 1.25263 3.90533 -90 4 53.556 2.88446 38.4204 4.77396 -6.45058 -3.13498 -91 4 52.5519 1.98529 39.6413 5.25091 8.27159 -2.68354 -92 1 50.4114 5.20625 35.6841 -20.1476 8.87025 -3.50293 -93 2 49.1688 5.73971 35.0966 -28.9774 8.99335 -1.66554 -94 2 48.0726 4.67952 35.3573 13.5632 -27.7837 -20.7653 -95 3 48.2724 3.51151 34.9309 -12.9152 20.0019 12.3092 -96 4 50.758 4.377 35.1895 1.67728 -2.63512 -1.50997 -97 4 48.8371 6.69602 35.5973 10.748 -7.18216 5.66994 -98 2 49.2038 6.04752 33.5367 10.0422 21.5226 29.5984 -99 2 47.9776 6.84135 32.9981 5.60977 17.6728 -19.5296 -100 2 48.06 7.31101 31.4919 41.3779 8.51018 8.58065 -101 2 48.2223 6.22581 30.3803 10.2277 10.7815 -8.37061 -102 1 48.1882 6.76889 29.0124 -44.0668 -20.3552 -6.98541 -103 4 49.2392 5.11894 32.9842 10.5057 -23.1259 -12.3022 -104 4 50.1653 6.62923 33.3927 -11.345 -5.02104 -10.4632 -105 4 47.825 7.77207 33.6051 2.48464 -5.23088 2.05035 -106 4 47.0343 6.2773 33.0942 -1.95432 -7.79908 6.21428 -107 4 48.9189 8.07819 31.4105 -13.7973 -19.6161 -0.159439 -108 4 47.1832 7.92091 31.2683 -17.7289 5.61577 -2.96622 -109 4 47.3306 5.536 30.4593 16.0468 -5.76301 1.4082 -110 4 49.2642 5.74618 30.4425 -24.8663 -4.45667 9.08666 -111 4 48.9827 7.28362 28.7526 29.3958 17.558 -6.10605 -112 4 47.3901 7.43056 28.8463 17.4375 -26.0151 1.0329 -113 4 48.1308 5.99149 28.2967 -4.23626 26.2635 18.8845 -114 1 46.923 5.03715 35.9679 -17.5656 23.7329 15.0201 -115 2 45.6707 4.26397 36.0383 7.41887 0.1342 36.2715 -116 2 44.9083 4.3955 34.7419 -9.99807 18.7078 -56.0122 -117 3 45.3082 5.1515 33.8118 -11.5681 -21.3087 27.1246 -118 4 46.8218 5.98238 36.4144 8.23522 -16.4135 -11.8728 -119 4 45.8989 3.17264 36.1884 2.80321 2.94058 -5.13324 -120 2 44.7401 4.70263 37.2808 -1.60464 -36.3649 -20.2774 -121 3 44.4616 6.07663 37.208 27.8602 32.4116 16.0792 -122 2 45.244 4.25605 38.6868 21.6281 49.2853 -20.5016 -123 4 43.7497 4.17807 37.1099 13.0537 7.54308 5.65065 -124 4 45.2592 6.57873 37.5303 -28.9412 -17.1189 -11.5145 -125 4 45.9129 5.11546 39.1089 -19.7485 -23.953 -1.10378 -126 4 45.8752 3.36487 38.6536 3.71139 -12.8851 -1.61893 -127 4 44.3595 4.03827 39.3021 -3.33201 1.23649 16.0156 -128 1 43.7613 3.66416 34.5997 13.2589 -16.0433 44.4251 -129 2 42.7828 3.62815 33.5465 18.9204 -1.21878 -42.6601 -130 2 41.7763 4.78741 33.7016 8.26701 -3.22526 52.4496 -131 3 41.2647 5.35582 32.7525 -2.05798 3.57411 -28.7638 -132 4 43.4932 3.04471 35.4154 4.99312 14.665 -20.8764 -133 4 43.36 3.79542 32.5266 -17.2288 -0.741434 30.8189 -134 2 42.0901 2.2209 33.4572 -3.06831 -30.079 -8.91003 -135 2 42.9343 0.899345 33.7586 6.86735 -2.69949 -8.81151 -136 2 42.2038 41.463 33.3849 1.50493 16.9918 14.9247 -137 2 44.2499 0.864187 32.9361 47.2855 12.5868 41.6398 -138 4 41.5678 2.05281 32.481 6.79941 12.0418 -2.16148 -139 4 41.2531 2.16469 34.1657 -6.29243 10.0771 8.19014 -140 4 43.198 0.869694 34.8519 -1.4112 0.953999 -4.44245 -141 4 42.8702 40.5903 33.6002 -4.10478 0.398246 -9.68788 -142 4 41.7896 41.4589 32.3582 7.27854 -3.68783 -7.38435 -143 4 41.3262 41.3063 34.0224 -6.75638 1.39507 6.42691 -144 4 44.0947 0.829251 31.8728 -5.75954 4.64229 -28.5029 -145 4 44.9396 41.8855 33.1737 -20.9549 12.1515 -1.19165 -146 4 44.9309 1.76601 33.2059 -22.5069 -20.3291 -10.4095 -147 1 41.5145 5.2236 34.9901 10.2672 4.08625 -51.0356 -148 2 40.6676 6.35891 35.268 -24.1778 -10.7223 -7.79527 -149 2 41.3691 7.72376 35.0974 2.95483 13.7574 -3.11119 -150 3 40.6975 8.75349 34.8431 -2.15612 -12.5202 3.44484 -151 4 41.8176 4.64617 35.7553 2.04542 -7.36824 24.1106 -152 4 39.8621 6.3427 34.4551 10.5786 9.41727 7.44594 -153 2 39.8405 6.1283 36.5756 19.8539 -2.67173 26.8296 -154 3 40.7601 5.89106 37.6735 -0.128972 20.3018 -14.678 -155 2 38.9248 4.89402 36.5497 -24.3083 -6.19306 -11.8519 -156 4 39.228 7.01129 36.8511 -0.372961 8.24506 -6.20484 -157 4 41.1549 6.75425 37.8536 -4.13097 -9.7211 -3.01543 -158 4 38.1722 4.94482 35.71 1.05658 9.14576 13.4136 -159 4 38.3953 4.71355 37.5213 -1.28546 9.2328 -6.30902 -160 4 39.3771 3.92967 36.3433 23.1336 -11.0543 -1.24287 -161 1 42.7302 7.8059 35.1562 3.49276 1.34371 4.78693 -162 2 43.5269 8.99303 34.9539 -8.19772 -21.7996 13.9087 -163 2 44.4646 9.39471 36.0778 41.0762 49.5413 -62.5687 -164 3 45.3993 10.2183 35.7654 -29.643 -36.0587 21.7786 -165 4 43.357 7.05719 35.4614 -7.13629 -15.5308 5.06399 -166 4 44.0803 8.92821 34.0189 14.2015 -9.60403 -10.8131 -167 4 42.9032 9.83742 34.7399 -16.6431 23.0824 1.78637 -168 1 44.28 8.95267 37.3076 -5.41717 -6.01048 56.4016 -169 2 45.1954 9.30059 38.3934 14.0544 9.09198 9.45122 -170 2 46.5736 8.71838 38.034 -4.40481 25.0392 4.24124 -171 3 46.7239 7.52665 37.7592 -2.06685 -10.8071 -7.31186 -172 4 43.4369 8.46722 37.66 -0.808029 1.80219 -13.797 -173 4 45.2932 10.4319 38.4595 -5.35026 -12.3633 -15.6489 -174 2 44.7775 8.83735 39.8303 19.1756 -23.9015 -7.23155 -175 2 45.4882 9.63492 40.9425 5.24315 -15.5914 27.8506 -176 2 45.0424 11.1143 41.0465 6.36216 -11.291 -10.339 -177 2 45.9827 11.9035 0.041605 38.3537 -2.96327 34.4916 -178 1 45.5586 13.2421 0.396463 -0.785075 15.3756 28.9492 -179 4 44.9912 7.72238 39.9953 -4.79728 17.8629 -7.78445 -180 4 43.7049 8.96345 39.9422 -22.2512 0.44531 4.07292 -181 4 46.5908 9.56019 40.8161 0.364544 3.82252 -6.52459 -182 4 45.3434 9.10335 0.0599805 -5.24686 13.9981 -23.7842 -183 4 44.0132 11.1324 41.4274 -10.2695 3.39123 6.70816 -184 4 44.9981 11.6023 40.04 1.8072 0.416607 6.15726 -185 4 47.0442 11.9436 41.5493 -17.6115 6.73335 -5.13538 -186 4 46.1824 11.4052 1.05233 -16.0491 -0.928483 -18.7699 -187 4 45.666 13.9003 41.5429 -6.15709 2.25656 -0.794581 -188 4 46.187 13.6261 1.17403 -31.6799 -14.737 -27.4943 -189 4 44.5482 13.2658 0.707841 33.0262 6.71149 -7.77427 -190 1 47.5786 9.61919 37.9975 -0.262725 18.6124 2.96873 -191 2 48.9681 9.33197 37.6414 -20.2336 1.72319 -17.1083 -192 2 49.7588 9.70622 38.88 39.5209 -76.7499 14.8721 -193 3 49.6145 10.763 39.4317 -9.44289 38.5374 13.5639 -194 4 47.4009 10.6083 38.3248 7.77058 -18.5649 -8.96176 -195 4 49.0172 8.23798 37.4216 9.46753 0.884559 0.506936 -196 2 49.3323 10.1282 36.3163 3.6714 0.82331 31.2642 -197 3 48.3563 9.85046 35.3281 -8.1318 -4.77519 -4.71381 -198 2 50.6865 9.72677 35.695 -19.0046 0.743943 -11.7808 -199 4 49.2557 11.2077 36.6021 8.67648 2.0602 -8.11811 -200 4 47.5419 10.2678 35.5977 -2.15846 0.170791 -0.678761 -201 4 50.8563 10.2671 34.7416 2.67544 8.24981 1.47477 -202 4 50.7066 8.66813 35.3754 2.1247 -7.47433 7.78713 -203 4 51.5309 9.954 36.3541 9.43429 -0.352141 7.40173 -204 1 50.5004 8.65755 39.48 -48.513 49.986 -45.0014 -205 2 51.0618 8.74392 40.7907 20.8089 -26.4742 28.5407 -206 2 52.5708 8.35776 40.7906 -32.7343 -31.0986 -30.3541 -207 3 52.9098 7.36002 40.1044 19.6712 31.5314 12.7437 -208 4 50.5882 7.8265 38.898 12.8881 -18.9119 10.2231 -209 4 50.9863 9.78895 41.141 -1.46865 8.60563 4.12328 -210 2 50.3037 7.79505 41.8358 -16.725 28.936 13.8764 -211 2 50.252 6.27959 41.4904 27.2589 15.6434 -4.64867 -212 2 48.8609 8.35011 0.225019 8.85004 14.588 -17.6069 -213 2 49.3953 5.42325 0.497373 -18.8945 7.05888 30.2377 -214 4 50.814 7.95159 0.918621 8.35305 -8.94958 -7.30269 -215 4 51.3186 5.93048 41.4774 -6.84536 -5.23847 5.64953 -216 4 49.9408 6.1608 40.4387 -8.33431 -3.05112 -5.55566 -217 4 48.166 7.96072 41.344 -1.46 7.63128 5.53427 -218 4 48.8165 9.51657 0.246026 0.467008 -30.2893 -0.065267 -219 4 48.5175 7.97406 1.21641 -4.07563 3.27994 -1.48455 -220 4 48.2983 5.58085 0.347667 5.50609 -0.627552 -5.84055 -221 4 49.5344 5.58322 1.60624 7.63779 5.91871 -13.4594 -222 4 49.5909 4.36583 0.361303 3.03099 -20.7712 -9.01704 -223 1 53.3669 9.15083 41.5136 39.5682 14.7354 5.79836 -224 2 54.8443 9.26777 41.6313 -32.7918 27.0996 3.53674 -225 2 0.372396 8.2907 0.722751 15.0567 -33.4937 20.6099 -226 3 54.8856 8.2259 1.87915 11.4238 -3.26125 -20.3466 -227 4 52.9167 9.73978 0.288924 -10.841 14.2188 11.5997 -228 4 0.25416 9.07559 40.636 9.98484 -5.7038 -17.1316 -229 2 0.351513 10.7152 0.19938 0.985642 14.1538 -10.6635 -230 3 54.4575 11.7797 41.7528 -11.3464 -18.6066 -9.73211 -231 2 1.66903 11.1049 41.4122 7.34382 -22.4378 -10.8926 -232 4 0.4803 10.8256 1.29559 2.15483 -15.9854 6.57991 -233 4 54.1789 12.1729 0.660397 -4.76608 7.18995 2.46446 -234 4 2.02372 12.0909 41.706 2.9877 17.6459 6.95349 -235 4 1.57896 11.139 40.2943 0.339955 -2.68366 6.65003 -236 4 2.50746 10.4017 41.6821 -7.50419 3.69742 -2.77337 -237 1 1.45709 7.55056 0.343709 0.783377 10.0466 -6.42735 -238 2 2.26763 6.65075 1.15078 -32.6055 -6.94536 -7.22798 -239 2 3.71498 6.9634 0.985171 49.9575 39.4499 -62.468 -240 3 4.16139 7.41516 41.7733 -24.7374 -20.1855 46.264 -241 4 1.86812 7.64334 41.3079 -3.10568 2.79536 2.39364 -242 4 2.02547 6.77359 2.21072 -7.15361 5.99983 10.1715 -243 2 1.97017 5.19949 0.677115 9.24237 23.8034 -8.70369 -244 2 0.525 4.76245 0.942436 -1.25511 -23.3688 27.6866 -245 2 0.292475 3.39123 0.300736 12.896 -21.1671 11.4366 -246 2 0.300138 4.59931 2.47443 -32.0383 1.7301 9.08136 -247 4 2.70003 4.54767 1.15632 6.2908 -16.3803 10.1517 -248 4 2.22696 5.13751 41.5068 -3.29253 -1.30987 -4.15087 -249 4 54.7656 5.47042 0.590489 -8.39992 14.3218 -15.0438 -250 4 54.2418 3.05018 0.328915 -13.2626 1.11831 3.00682 -251 4 0.884488 2.58096 0.823664 -4.50955 14.351 -5.98985 -252 4 0.593908 3.34298 41.1636 3.48003 3.40906 -16.1017 -253 4 0.952355 3.83641 2.92287 8.67303 -5.41594 2.10418 -254 4 54.195 4.2418 2.71744 29.7111 15.4634 -7.25797 -255 4 0.523461 5.5584 3.03176 -8.55492 -11.4476 -4.98522 -256 1 4.54724 6.69628 2.0028 -11.6083 -5.66543 -5.23244 -257 2 5.9708 6.78048 2.07185 29.6953 24.7002 11.5216 -258 2 6.62679 5.47067 2.57826 -56.9161 -25.5018 -48.7527 -259 3 7.55514 5.44421 3.3345 43.3901 -4.04961 27.9945 -260 4 4.11753 6.29088 2.82459 -1.31884 -6.15538 19.0144 -261 4 6.38329 6.99012 1.0501 -1.44469 -12.2628 1.79191 -262 2 6.4556 7.99651 2.97484 -29.1307 10.2847 -18.0571 -263 2 6.5028 9.34873 2.22705 -18.2939 24.7932 5.04877 -264 2 6.67525 10.5485 3.20576 -19.6949 -28.8822 -17.9407 -265 3 7.83409 10.9407 3.49149 14.4815 4.00472 5.8048 -266 3 5.6204 11.0576 3.67938 3.00737 1.04452 3.25275 -267 4 7.46376 7.72864 3.29072 15.5933 3.84479 14.8832 -268 4 5.82416 8.22265 3.87848 3.62309 -20.6245 -0.107855 -269 4 5.50278 9.55154 1.65377 27.7023 -9.35583 7.15892 -270 4 7.36204 9.37759 1.52673 -1.86837 -2.39822 -10.1271 -271 1 6.01547 4.32119 2.13096 24.825 18.8056 21.8908 -272 2 6.40109 2.94617 2.38906 -11.7575 -20.1643 -12.9237 -273 2 7.81521 2.61654 1.77783 -56.2322 2.45294 33.4207 -274 3 8.31478 3.35811 0.966233 17.239 19.087 -22.9985 -275 4 5.23593 4.40493 1.50032 -13.4301 6.78787 -12.4159 -276 4 6.42741 2.74871 3.48587 6.57798 6.02642 3.28221 -277 2 5.2086 2.00284 1.82478 32.9723 -19.5112 -16.552 -278 2 3.90497 2.10853 2.63909 4.11684 35.775 58.6384 -279 2 4.90372 2.28313 0.318971 -25.0993 -16.9694 6.10511 -280 4 5.56913 0.900136 1.85726 -4.66192 22.2662 6.6067 -281 4 4.03562 1.77943 3.74204 2.08752 -4.13501 -29.3045 -282 4 3.08076 1.58512 2.20328 -21.6762 -25.4002 -11.7361 -283 4 3.47043 3.14079 2.79739 15.5883 -5.24062 -11.8252 -284 4 4.40039 3.24668 0.146776 -5.79992 5.24774 -1.28692 -285 4 4.20501 1.47402 41.8336 8.41255 14.6516 3.66501 -286 4 5.77159 2.28177 41.569 16.6343 -1.64949 -4.80555 -287 1 8.4358 1.54559 2.27475 36.6082 -11.5601 -11.8896 -288 2 9.77403 1.09441 1.8307 -27.8835 12.6882 -14.7267 -289 2 9.60932 41.7912 0.904414 -8.95822 -4.80133 -2.77359 -290 3 8.60977 41.0717 1.04857 16.9017 -0.350054 -8.54673 -291 4 7.96937 0.851078 2.83344 -16.1443 -13.3321 15.6909 -292 4 10.1447 1.96102 1.23179 21.7718 -7.90657 2.9301 -293 2 10.6071 0.627222 3.03652 -0.441548 -3.06629 28.3632 -294 2 11.1182 1.69736 4.03374 -39.6019 -9.33118 23.345 -295 2 12.4276 2.26482 3.60541 40.3504 -3.80329 2.03759 -296 3 13.4833 1.65854 4.00477 -10.9735 16.3163 -6.96273 -297 3 12.4619 3.21875 2.76405 -4.75337 -1.04793 7.93588 -298 4 11.5429 0.117807 2.72279 -4.90068 -9.43781 -6.0473 -299 4 9.98495 41.7532 3.61242 16.0495 13.2539 -10.4034 -300 4 11.2741 1.17979 5.05068 -3.18835 9.28581 -16.8758 -301 4 10.3234 2.48031 4.23808 10.2695 -6.11036 -3.24845 -302 1 10.6563 41.4604 0.0588169 -6.20046 -15.666 -8.24155 -303 2 10.7096 40.1842 41.1911 4.64874 21.5238 9.65168 -304 2 10.6577 38.9638 0.161439 -6.67174 -46.3648 23.9629 -305 3 10.1435 37.8848 41.6696 11.1653 29.5239 15.2576 -306 4 9.85832 40.1011 40.5066 -14.3391 4.69386 -5.52668 -307 2 12.0141 40.2124 40.3653 4.26726 1.71904 -5.44169 -308 2 12.4668 41.6661 40.4777 -1.00635 15.6111 -33.0282 -309 2 11.8673 0.323303 41.767 -12.6506 -21.5702 -15.1443 -310 4 11.8545 39.873 39.2959 0.539662 6.91875 10.5587 -311 4 12.8304 39.5641 40.7546 -3.32338 -3.68521 7.20301 -312 4 12.0951 0.327352 39.5607 -0.26902 -6.73625 15.8499 -313 4 13.5766 41.7696 40.398 -3.05617 -0.547794 6.53436 -314 4 11.6542 1.3898 41.6565 2.06281 16.0871 1.21765 -315 4 12.5433 0.162045 0.691867 15.5992 2.8717 16.0141 -316 1 11.2193 39.0766 1.4086 -4.36655 24.7542 -22.059 -317 2 11.4309 38.0888 2.42328 2.01986 -2.25877 10.0578 -318 2 10.2357 37.7662 3.3374 -3.13249 5.62439 -12.9442 -319 3 10.4243 36.9709 4.25096 -6.41092 -9.96708 1.94465 -320 4 11.5904 40.0068 1.66465 -1.36758 -8.10945 4.45955 -321 4 11.6246 37.1209 1.91909 1.66244 -5.96089 -4.69733 -322 2 12.7089 38.4628 3.26447 -19.7243 1.96837 18.865 -323 3 12.593 39.7548 3.85012 -16.3579 -13.4437 -0.292868 -324 4 13.6002 38.4999 2.63657 13.9756 -7.10852 -11.694 -325 4 12.8962 37.7302 4.10036 -1.36843 4.44789 -10.4248 -326 4 11.9859 39.6657 4.60642 10.4094 13.6351 -5.41979 -327 1 9.02275 38.3618 3.12708 -24.8633 34.0603 -47.8229 -328 2 7.7797 38.1104 3.9237 -5.5143 -4.40103 -12.4219 -329 2 6.80948 37.1627 3.16843 27.134 16.5749 8.61656 -330 3 6.86683 37.0056 1.95165 6.52379 13.0808 -10.3152 -331 4 8.81363 38.9852 2.21874 13.7891 -35.0234 50.9651 -332 4 8.06628 37.5753 4.84119 7.22917 -10.5654 7.4735 -333 2 7.01568 39.4093 4.3407 2.69101 -11.9593 -14.7657 -334 2 7.81876 40.1019 5.42325 -6.79454 3.60365 -28.1432 -335 3 8.28496 41.241 5.20721 -2.75331 10.4655 -0.123769 -336 3 8.08719 39.4782 6.47272 0.652509 -5.2024 22.4807 -337 4 5.97814 39.1687 4.67547 5.82193 1.31451 7.85599 -338 4 6.83632 40.0167 3.42407 6.48365 7.00102 3.75656 -339 1 5.92582 36.4787 3.90047 -14.2639 -13.8348 21.4567 -340 2 4.95916 35.6178 3.24268 -4.4575 6.83929 8.3992 -341 2 3.83929 36.4769 2.71202 -44.4588 -49.3176 -48.5312 -342 3 3.60925 37.6169 3.05258 2.07424 26.7384 14.4764 -343 4 5.8145 36.534 4.942 7.63157 5.21975 -16.3776 -344 4 5.40617 35.1414 2.34351 4.65472 -4.22423 0.555341 -345 2 4.39718 34.509 4.16235 13.2774 -34.7614 9.16528 -346 3 3.98438 35.0519 5.39575 -10.4467 6.31908 32.28 -347 2 5.50619 33.4543 4.48033 -18.4692 -3.54598 29.0115 -348 4 3.53919 33.9402 3.74776 -4.47694 5.79242 -10.2957 -349 4 3.62452 34.3759 6.00064 11.5458 5.5573 -22.0279 -350 4 5.86065 32.9579 3.58801 8.19644 -6.15464 -22.9143 -351 4 5.08151 32.5761 5.12909 16.3877 29.7333 -11.6263 -352 4 6.39565 33.9521 4.95041 -3.85278 -8.84208 3.35803 -353 1 2.97294 35.7888 1.83357 24.6732 25.9217 25.2152 -354 2 1.71267 36.3687 1.37347 -5.03432 -5.896 10.5631 -355 2 0.744229 36.5497 2.58991 -5.24139 24.3125 -23.8477 -356 3 54.9871 37.5497 2.63122 18.6385 -17.0409 3.73872 -357 4 3.28773 34.8825 1.44268 -6.98273 2.93822 -0.272558 -358 4 1.87243 37.434 1.07109 4.86902 -3.5162 -5.74397 -359 2 1.111 35.5523 0.154125 -16.9781 -2.34719 28.1775 -360 2 1.71191 35.9998 40.7076 5.75717 0.931703 -28.4951 -361 2 54.5365 35.7134 0.116808 -8.16561 0.919103 1.38616 -362 2 3.27145 35.9095 40.6267 -43.0781 7.09941 -3.6072 -363 4 1.31237 34.4411 0.36052 2.96229 18.9121 -10.1464 -364 4 1.38444 37.0145 40.3207 4.07875 -5.77915 19.4423 -365 4 1.27316 35.3433 39.9124 8.37762 -5.40948 6.65521 -366 4 54.0772 35.0942 41.2103 3.74338 3.48587 4.89864 -367 4 54.2123 36.7722 41.8688 5.5832 -2.69651 -3.34762 -368 4 54.0157 35.4055 1.08169 10.5414 -0.491815 -14.4897 -369 4 3.61367 34.902 40.8802 7.83264 -12.2373 1.45006 -370 4 3.69229 36.6315 41.3343 12.2091 5.94613 6.19684 -371 4 3.59275 36.1798 39.604 6.95495 -3.49191 -4.00644 -372 1 0.74604 35.6172 3.54454 -3.3388 -35.9018 49.598 -373 2 0.0112331 35.6552 4.85892 21.257 7.22823 -39.6883 -374 2 0.198256 37.0471 5.48367 -2.86302 -31.8341 -17.2866 -375 3 54.1912 37.6952 5.75353 -1.48181 26.0574 3.92406 -376 4 1.16676 34.6739 3.4098 -0.571923 12.3969 -9.16993 -377 4 53.9399 35.5324 4.59955 -13.6683 1.62606 4.36563 -378 2 0.479844 34.4894 5.77304 -8.63544 -0.437888 22.4632 -379 2 54.7769 34.3327 7.14546 -8.87326 -9.27459 2.92058 -380 2 0.0146857 35.4787 8.12524 6.60033 -5.57439 2.5368 -381 3 54.0952 36.3427 8.3329 8.35004 -1.43527 5.86114 -382 3 1.11008 35.478 8.75909 4.47833 6.11486 1.03148 -383 4 1.57132 34.5563 5.98457 -0.698959 1.91632 -4.64924 -384 4 0.309529 33.5134 5.28188 2.4365 -3.54209 -11.468 -385 4 0.179249 33.4003 7.64738 0.479338 5.67065 -5.66203 -386 4 53.6776 34.105 7.04833 9.83525 6.91672 -4.06122 -387 1 1.48459 37.3964 5.63734 26.9411 18.0032 -4.38534 -388 2 2.00708 38.6625 6.18614 -17.3218 -26.0277 -29.9987 -389 2 1.56827 39.8885 5.33406 1.07082 -15.6319 68.2882 -390 3 1.08143 40.8395 5.94485 1.04665 3.34176 -10.6171 -391 4 2.21263 36.6994 5.39095 -3.57075 5.04293 0.958686 -392 4 1.48422 38.7142 7.17744 15.2971 12.5748 0.959573 -393 2 3.55969 38.5843 6.25222 7.32448 -15.8569 15.0135 -394 2 4.09689 39.7132 7.09894 -5.63198 1.92213 9.01267 -395 3 4.56636 40.7179 6.56654 0.030916 3.04529 -1.1693 -396 1 3.96361 39.556 8.43894 1.042 12.9555 16.4237 -397 4 4.05831 38.7157 5.24953 -10.2579 -5.90723 4.64011 -398 4 3.91694 37.5778 6.70114 -5.07122 23.1073 -10.2752 -399 4 3.40266 38.7698 8.86734 10.6722 14.2638 -7.23316 -400 4 4.31989 40.3411 9.06061 -10.7144 -22.9188 -14.0526 -401 1 1.60475 39.819 4.02334 -43.55 39.5967 -43.6917 -402 2 0.959151 40.8062 3.12947 9.93922 10.0651 20.657 -403 2 54.4776 41.0208 3.48285 -52.4492 -13.4217 15.5726 -404 3 53.9715 0.237442 3.65017 19.1527 -10.2385 2.60078 -405 4 2.04263 39.1125 3.49268 25.4866 -43.7222 -11.6271 -406 4 1.43469 41.7946 3.36052 -1.16639 -0.650149 -3.04645 -407 2 1.13376 40.5205 1.61049 -4.45578 -2.70165 -27.9407 -408 2 0.490261 41.6149 0.695896 4.53105 0.20202 29.6943 -409 2 2.64975 40.4484 1.23692 -3.92583 -1.39436 -18.6979 -410 4 0.60342 39.5705 1.32385 8.41785 -1.89228 7.96418 -411 4 54.3692 41.6195 0.82936 4.25856 9.6792 3.81375 -412 4 0.622371 41.4492 41.5424 7.52435 -6.48816 -19.7965 -413 4 0.973053 0.688907 0.936332 -12.1275 -4.49455 -2.44597 -414 4 2.86969 40.4983 0.122209 -12.9804 -12.5133 18.6513 -415 4 3.14027 39.5547 1.69882 2.20392 3.04031 -6.93039 -416 4 3.17994 41.3387 1.56797 8.55742 10.8937 16.8775 -417 1 53.6665 39.902 3.64569 3.02926 35.878 11.6697 -418 2 52.2466 39.9148 4.06102 19.2385 27.0707 -26.8098 -419 2 52.053 40.5369 5.44904 5.36155 -11.3244 -6.70427 -420 3 51.0493 41.2119 5.6977 3.00195 1.8183 -1.23959 -421 4 54.0359 38.9941 3.4462 12.1828 -26.316 -3.91411 -422 4 51.7731 40.6655 3.34079 -4.82064 -14.7659 11.8755 -423 2 51.582 38.5149 3.95778 -5.61462 -20.1546 -9.91009 -424 2 51.4355 37.9559 2.49174 21.0062 -12.2216 22.8132 -425 2 51.0144 36.4629 2.37849 -12.7289 -13.0945 -11.3158 -426 2 50.8009 35.9817 0.883468 22.3055 45.8074 13.5352 -427 1 50.1864 34.6873 0.684667 2.36531 28.1154 -10.556 -428 4 50.5344 38.5648 4.38466 13.3699 -2.49694 2.21203 -429 4 52.2198 37.7725 4.53757 -13.8611 9.51826 -2.20414 -430 4 52.4594 37.9738 2.01537 -10.7122 14.3169 -4.94324 -431 4 50.6781 38.6054 2.01085 7.27079 0.282464 -15.5314 -432 4 50.0599 36.3043 2.92579 -2.19776 -0.350037 2.41174 -433 4 51.7586 35.7685 2.83822 0.223715 4.6579 4.31096 -434 4 51.8274 35.9658 0.402852 -15.0801 -2.53131 0.358002 -435 4 50.2142 36.8299 0.38331 4.02889 -26.7998 -2.47013 -436 4 50.6312 33.9821 1.2741 -7.74727 -6.99272 -14.4028 -437 4 50.1255 34.5169 41.5875 17.6482 -15.4813 7.31014 -438 4 49.2229 34.7469 0.909632 -22.6621 -5.40937 19.0501 -439 1 53.014 40.2496 6.3528 -7.33511 22.7823 24.6419 -440 2 53.0995 40.7279 7.73814 -49.8191 -29.044 -3.24915 -441 2 53.1557 0.329785 7.7965 36.8238 12.814 -39.8954 -442 3 52.5287 0.997511 8.60414 -15.9304 4.02299 13.5617 -443 4 53.7341 39.5741 6.15629 12.7417 -17.108 -13.0125 -444 4 52.0658 40.401 8.2322 35.0205 13.5384 -7.46142 -445 2 54.2887 40.0362 8.44194 -31.1952 -6.28028 37.9979 -446 4 54.3393 40.3597 9.51814 11.9598 15.0179 -15.3163 -447 4 0.207826 40.1934 7.85611 17.4499 5.7482 6.56468 -448 4 54.1321 38.9464 8.61757 0.233079 -2.0185 -17.8759 -449 1 53.9798 0.938968 6.8679 -0.195991 -19.5991 -5.8991 -450 2 54.0539 2.3703 6.69095 -13.0728 33.3033 12.6105 -451 2 52.7411 3.03405 6.19669 -13.7918 -57.342 -43.9621 -452 3 52.3429 4.1409 6.51048 0.805927 21.8583 24.6591 -453 4 54.6966 0.402301 6.30051 -22.9471 7.504 14.9388 -454 4 54.1387 2.85352 7.70963 6.90446 -7.48262 -5.16091 -455 2 0.230181 2.82991 5.77971 -8.39605 37.5401 -18.7849 -456 2 1.62806 2.36187 6.13631 43.8101 -17.859 13.5365 -457 2 2.01439 2.63812 7.6434 4.44409 -15.8917 -34.667 -458 2 3.251 1.82053 8.03886 10.3698 -25.435 21.3536 -459 1 3.78609 2.13458 9.37971 -1.03569 -21.7613 -70.4054 -460 4 0.236987 4.00662 5.72725 -0.841737 -32.3075 1.88093 -461 4 55.0233 2.47547 4.72977 -1.92078 4.0191 4.58104 -462 4 2.43886 2.84427 5.52141 -13.7997 6.98566 -1.14785 -463 4 1.8001 1.26942 5.8525 -13.1218 12.7308 11.199 -464 4 1.17734 2.2629 8.25415 -4.76662 9.03037 15.6753 -465 4 2.26439 3.72233 7.77766 -11.2971 -1.006 3.39024 -466 4 4.0605 1.91272 7.29579 6.96563 5.43042 -1.59904 -467 4 3.03028 0.709673 8.06144 -4.99399 12.6268 -3.20223 -468 4 3.89697 1.2978 9.90866 2.2165 -13.9672 17.3419 -469 4 3.11983 2.70535 9.83652 -2.18207 25.7622 26.4666 -470 4 4.71792 2.51816 9.23842 -3.78155 13.4581 18.6473 -471 1 52.0021 2.30339 5.27929 12.8772 20.7449 44.6796 -472 2 50.6928 2.72834 4.84618 -13.8318 -0.832969 -24.58 -473 2 49.579 2.58092 5.91693 0.565718 25.7533 -2.22664 -474 3 48.7752 3.51298 6.10069 9.60089 -13.9081 0.0850852 -475 4 52.4111 1.47967 4.84803 3.54375 -13.752 -6.04623 -476 4 50.7183 3.81521 4.5849 2.62435 0.742467 8.46338 -477 2 50.3339 2.0499 3.47904 12.4361 -26.7668 8.24264 -478 2 51.3981 2.34325 2.36407 -25.9391 22.844 -14.5031 -479 2 48.9153 2.37958 2.98651 -2.89914 40.9383 9.35249 -480 2 51.1891 1.41918 1.15407 38.5806 -15.4927 -30.3188 -481 4 50.4158 0.92469 3.65006 -8.90797 13.02 4.48026 -482 4 52.4055 2.20648 2.74929 18.7984 -5.45377 5.09466 -483 4 51.3666 3.42411 2.00589 -1.76359 -13.5005 7.53435 -484 4 48.1353 2.36077 3.79579 2.75746 -16.6411 -10.078 -485 4 48.6799 1.76326 2.11438 -14.9792 -11.0957 -5.84075 -486 4 48.8325 3.45193 2.63807 7.50371 -11.7896 -0.401559 -487 4 52.1004 1.43799 0.414216 -21.3416 1.39174 26.2203 -488 4 50.3409 1.68288 0.503068 -10.2032 3.93981 2.99084 -489 4 51.0565 0.33979 1.46483 1.72575 11.8892 -3.22767 -490 1 49.5807 1.53255 6.75244 19.5889 -24.3514 7.76629 -491 2 48.7262 1.39688 7.92951 3.12598 20.2674 -1.73108 -492 2 48.8873 2.63773 8.86406 -22.8968 -16.6402 -5.42224 -493 3 47.8891 3.05472 9.45614 -0.472007 6.27789 -5.95623 -494 4 50.2352 0.731103 6.58688 -10.8709 15.7502 1.66713 -495 4 47.6402 1.39986 7.60999 11.2933 -0.131061 -1.07735 -496 2 49.0614 0.0990051 8.70607 -29.9824 -25.1823 -11.7347 -497 2 48.2869 41.7602 10.01 13.4599 -0.122667 29.7563 -498 2 46.7828 0.0292377 10.0132 -0.929007 -24.4408 -23.1824 -499 3 46.2118 0.52149 10.9702 -12.9016 15.2185 13.9881 -500 1 46.1401 41.3429 8.96595 27.5879 22.2376 34.4467 -501 4 50.107 0.108866 8.97457 27.7162 -1.73681 3.74735 -502 4 48.8999 41.0818 8.03917 5.36927 20.2302 10.0129 -503 4 48.7183 0.460982 10.852 -8.35522 8.57003 -12.646 -504 4 48.4869 40.755 10.454 -1.65554 -4.90235 -14.5783 -505 4 46.6392 40.8985 8.22302 16.4703 -11.2583 -22.7525 -506 4 45.1487 41.2958 8.97726 -40.9601 -1.33251 0.190018 -507 1 50.0995 3.17318 9.05078 3.95851 -0.0485648 -3.79593 -508 2 50.3325 4.25644 9.97415 17.5873 21.0859 -2.62556 -509 2 49.9752 5.63804 9.37548 -18.0954 -29.5198 29.938 -510 3 49.379 6.45094 10.0988 9.73071 -4.74536 -2.58342 -511 4 50.9107 2.76055 8.59957 11.9693 -5.38147 -4.75744 -512 4 49.6509 4.09994 10.8399 -6.9467 2.38538 1.23714 -513 2 51.7744 4.26209 10.561 -12.6039 -21.2869 -0.279481 -514 2 51.8614 5.17465 11.7883 77.4573 -1.34868 -55.222 -515 3 50.9415 5.19238 12.5756 -62.6641 4.37367 45.7089 -516 3 52.9385 5.83334 11.9521 -15.5069 -3.45829 -0.856418 -517 4 52.5513 4.49045 9.80335 -1.41111 7.91559 -3.33271 -518 4 51.9847 3.17606 10.8252 3.56611 15.7947 8.37571 -519 1 50.1134 5.83384 8.05697 5.03044 -3.38183 -24.9476 -520 2 49.6949 7.07302 7.45907 -6.39224 21.6045 -14.6025 -521 2 48.2404 7.19765 6.96855 9.41443 -40.5535 -11.5325 -522 3 47.5994 8.23003 7.09737 -2.60339 17.4007 5.13595 -523 4 50.5903 5.18529 7.39903 -4.72806 0.48988 13.3104 -524 4 49.6568 7.79446 8.28532 6.84483 14.8177 6.93296 -525 2 50.7045 7.63108 6.39006 -19.8247 -9.47824 8.02755 -526 2 50.6996 6.84785 5.08902 -10.629 2.31661 -15.1243 -527 2 51.6586 7.26626 3.9659 -11.3496 43.5825 3.95364 -528 2 53.1317 7.00105 4.2557 32.8208 18.7244 -18.8206 -529 1 53.7683 7.95578 5.14747 -10.6729 7.59108 -11.9454 -530 4 51.7028 7.64661 6.81348 16.7201 -1.45014 11.0251 -531 4 50.4708 8.68128 6.19684 -5.34256 14.1207 -5.41714 -532 4 49.6713 6.8702 4.6668 -0.861277 1.74329 -1.61352 -533 4 50.8688 5.79892 5.31654 5.28855 -19.0543 2.54637 -534 4 51.4741 8.35024 3.65396 8.42695 -12.5098 16.2485 -535 4 51.3565 6.79125 3.04708 -1.5826 -26.0582 -19.3792 -536 4 53.7673 7.0998 3.31183 -20.6632 -9.77681 9.39502 -537 4 53.2972 5.98514 4.64126 3.7215 -8.75629 2.11801 -538 4 53.3251 8.87081 5.17658 4.71004 0.103302 -2.74719 -539 4 54.7439 8.12131 4.95956 10.0262 2.1061 -7.58392 -540 4 53.7752 7.60869 6.06781 -3.05466 -8.65204 35.212 -541 1 47.7159 6.1092 6.3306 31.3529 14.3598 14.0351 -542 2 46.4076 6.11425 5.7591 -25.7668 -19.0326 -13.8071 -543 2 45.4013 5.23171 6.47844 56.1675 -11.9112 16.6864 -544 3 44.23 5.34684 6.24133 -49.2229 2.39302 -4.99484 -545 4 48.3398 5.28969 6.15889 -17.2258 10.451 -1.21207 -546 4 45.9358 7.11624 5.83656 4.3919 7.44058 4.79016 -547 2 46.401 5.6982 4.25555 12.45 -16.5042 -24.1702 -548 2 46.8608 6.82251 3.28226 -4.83626 -15.1342 -13.4955 -549 2 46.0803 8.13881 3.30599 -14.5444 -4.79224 -13.1752 -550 3 44.9716 8.27119 2.67975 10.7775 -8.64163 7.28309 -551 3 46.5691 9.08454 3.95876 4.86602 16.815 8.62941 -552 4 45.3845 5.39013 3.90204 -1.72737 6.76951 8.44594 -553 4 47.0179 4.72632 4.06618 -9.2699 26.8442 8.77601 -554 4 46.8747 6.40942 2.20799 2.04532 8.89503 18.2744 -555 4 47.9008 7.08537 3.56457 7.18737 -1.18981 -5.53646 -556 1 45.8799 4.29222 7.33829 -37.7514 2.20406 -4.61566 -557 2 44.9987 3.41141 8.06424 -3.99299 1.7641 -5.76947 -558 2 44.3276 2.33248 7.21969 -45.1266 -42.7281 27.6017 -559 3 43.411 1.613 7.73718 25.6836 24.6852 -13.962 -560 4 46.8488 4.10168 7.49502 31.0353 -1.43619 1.82022 -561 4 45.5349 2.87862 8.87403 3.80662 2.65181 2.49747 -562 4 44.2009 4.01738 8.56522 2.51171 -3.43938 -1.53795 -563 1 44.7359 2.05713 5.97006 1.92732 3.23614 21.462 -564 2 44.1948 0.978467 5.13766 -26.7101 17.135 -13.9432 -565 2 44.8486 41.5478 5.5025 3.41127 -20.6454 16.5554 -566 3 46.0871 41.4431 5.57675 -14.0525 11.0231 2.35631 -567 4 45.5581 2.59183 5.73006 15.6975 -3.64086 -27.3416 -568 4 43.0338 0.980574 5.28193 28.569 -9.56263 1.83686 -569 2 44.4255 1.37435 3.62453 6.02041 -5.1027 -4.41971 -570 2 43.5303 2.62118 3.29791 4.64703 16.7196 -23.7169 -571 2 44.2051 0.148173 2.67978 -29.1583 2.83252 11.5038 -572 2 43.5747 3.10962 1.83395 1.21002 2.08355 -6.515 -573 4 45.4937 1.66977 3.44724 -0.165314 0.952935 9.41179 -574 4 43.8006 3.52551 3.92139 -2.56937 -12.5949 1.07415 -575 4 42.4611 2.43664 3.46298 -10.2855 -9.14552 12.9963 -576 4 44.5119 0.377143 1.64896 8.27723 -0.881131 -7.54742 -577 4 43.1044 41.7625 2.59144 16.8524 3.81389 6.96191 -578 4 44.7846 41.171 3.05101 -3.46686 1.83863 -12.0461 -579 4 44.5392 3.56167 1.57116 9.55733 8.13116 4.62467 -580 4 42.7809 3.86627 1.57982 6.14378 -4.69974 7.81616 -581 4 43.4757 2.31615 1.08375 -8.22918 -11.6964 -1.57482 -582 1 44.0839 40.4233 5.76821 21.932 -1.5334 -8.86254 -583 2 44.7424 39.1674 6.24443 -3.28027 29.5462 -2.23354 -584 2 45.6232 38.4648 5.15467 16.5957 -3.17533 31.1682 -585 3 45.1655 38.1269 4.0769 -9.06079 2.14789 -9.97198 -586 4 45.3594 39.5074 7.13461 -7.15079 -15.4686 -7.49065 -587 2 43.5266 38.3049 6.70081 12.2837 2.36218 -7.01546 -588 2 42.3912 38.8204 5.83129 -5.25874 0.19697 14.2242 -589 2 42.6515 40.3318 5.90174 -25.8883 17.7161 37.6601 -590 4 43.2615 38.5482 7.76954 6.63706 -13.879 -3.94164 -591 4 43.7406 37.2122 6.50504 -6.24398 7.50926 12.4246 -592 4 41.3856 38.4747 6.1895 5.24712 7.09666 -1.13826 -593 4 42.5101 38.4102 4.83081 -0.0162975 -1.57753 -20.806 -594 4 42.2783 40.7857 6.94925 18.7272 -16.9878 -38.5107 -595 4 42.0764 40.8825 5.13323 2.00122 -0.967094 -8.03005 -596 1 46.8623 38.0021 5.57674 -15.3549 -23.0767 -9.82664 -597 2 47.7161 37.0187 4.84527 -3.88045 42.2808 23.2471 -598 2 47.0384 35.8723 4.15029 10.1677 -9.37304 -39.3599 -599 3 47.4551 35.4743 3.0324 -9.4669 19.846 29.5852 -600 4 48.2252 37.6386 4.0698 7.54977 -11.2433 -2.33648 -601 2 48.6452 36.5035 5.99482 -10.0312 13.1223 -5.95218 -602 2 48.8959 37.7819 6.80046 -4.41071 -5.72741 24.5975 -603 2 47.4918 38.4151 6.80561 23.284 1.3706 -4.72721 -604 4 49.5844 36.0861 5.59811 5.91725 -9.04521 -0.913385 -605 4 48.1158 35.748 6.64071 6.83063 -0.71303 -5.46675 -606 4 49.6383 38.4449 6.34864 7.02588 7.83512 -10.7506 -607 4 49.3019 37.5753 7.85532 -11.9914 1.76609 -18.7023 -608 4 47.544 39.5162 6.85821 3.72706 6.34433 1.60956 -609 4 46.9486 38.0654 7.68542 -11.5693 -5.06488 12.3189 -610 1 46.0019 35.318 4.78064 -26.4221 -3.88232 27.7903 -611 2 45.3025 34.13 4.26579 26.8092 19.3149 11.5505 -612 2 44.4585 34.46 3.02929 16.6723 1.23881 35.6677 -613 3 44.3932 33.6565 2.12406 -6.96945 -13.3218 -23.6344 -614 4 45.6895 35.6839 5.72645 6.17072 -11.3773 -21.4598 -615 4 46.1371 33.4525 3.9443 -9.57056 -4.48549 -9.01935 -616 2 44.5851 33.4333 5.41517 7.28023 -34.3989 -9.31284 -617 2 43.896 32.1478 4.95943 -2.5072 53.7563 23.2534 -618 3 42.6929 32.0377 5.28407 -11.6877 -17.8688 -5.68187 -619 3 44.6212 31.2997 4.42805 15.8429 -32.9345 -13.4225 -620 4 43.8908 34.1037 5.87793 -28.8167 18.0933 10.1447 -621 4 45.2673 33.1449 6.25678 1.67129 3.14432 -6.05002 -622 1 43.9425 35.6996 2.93756 -0.354949 -32.7532 -51.8723 -623 2 43.3733 36.2033 1.70184 -38.6892 -13.1006 14.7431 -624 2 44.3694 36.8017 0.73913 15.0439 4.82349 -39.1461 -625 3 44.0609 36.9601 41.4463 -0.757384 -5.0254 19.6545 -626 4 44.0082 36.3398 3.67638 4.88567 37.3717 42.7902 -627 4 42.8639 35.3314 1.17484 15.8753 7.76257 0.915116 -628 2 42.1931 37.1947 1.98861 35.687 20.598 -23.7763 -629 2 41.116 36.6037 2.88066 -6.28281 10.7168 27.7809 -630 2 39.8788 37.4748 2.97821 -20.6793 -12.2331 -39.8799 -631 3 39.5744 38.0012 4.02693 -4.5695 14.1805 28.3661 -632 1 39.0796 37.534 1.86047 23.989 -9.69865 9.57867 -633 4 41.7899 37.5369 1.00167 -6.59533 -6.76427 4.06671 -634 4 42.6371 38.1477 2.39011 -7.96796 -7.2267 7.32793 -635 4 41.4745 36.4913 3.95075 -0.75248 -0.913082 -13.6466 -636 4 40.7949 35.61 2.55083 -3.16107 -12.1939 -5.02302 -637 4 39.3636 37.1043 0.951835 -4.89499 3.13933 11.6446 -638 4 38.1602 37.9899 1.92801 1.07188 2.17452 -2.18356 -639 1 45.5977 37.1878 1.1702 -15.0402 3.91697 -26.2999 -640 2 46.6124 37.7593 0.269692 0.961344 -25.1749 -6.20454 -641 2 47.1251 36.6298 41.227 -15.6894 27.1972 18.7996 -642 3 47.6617 35.6605 41.7393 11.2436 -21.3221 -9.23089 -643 4 45.7953 37.0706 2.14421 15.4189 2.49224 25.3654 -644 4 46.1246 38.4981 41.5406 -7.74237 14.7139 -7.84953 -645 2 47.8075 38.4099 1.03092 10.1012 15.6193 -18.1996 -646 2 47.4246 39.6903 1.82563 -12.4684 -22.6418 23.6998 -647 2 48.6005 40.4099 2.51691 -17.3417 -7.9082 6.23218 -648 3 49.6876 40.5582 1.97833 4.99301 -0.872474 -9.60266 -649 1 48.339 40.8761 3.75079 34.2245 13.1834 24.2049 -650 4 48.6123 38.7237 0.293834 -9.9427 -4.45455 6.13719 -651 4 48.2879 37.6501 1.66455 2.7768 -3.8165 9.90104 -652 4 46.6323 39.34 2.60232 21.0344 18.1725 -15.5096 -653 4 46.9544 40.4315 1.1644 -6.65764 6.44375 -5.56957 -654 4 47.4103 40.9551 4.17425 -6.86232 -2.61251 -1.04516 -655 4 49.1568 41.2536 4.3255 -23.3959 -10.5461 -18.532 -656 1 47.0132 36.8194 39.8944 4.79393 -10.5252 -5.84263 -657 2 47.6604 36.043 38.8342 19.1375 -30.0942 8.85154 -658 2 48.4687 37.0132 37.9763 6.82075 18.1877 -22.3602 -659 3 47.9595 37.6039 37.0009 8.77071 -9.81154 18.2462 -660 4 46.405 37.5569 39.5258 -2.34297 5.9549 -2.23138 -661 4 48.4229 35.2731 39.2798 -19.3933 25.0679 -4.92238 -662 2 46.6775 35.1997 37.9517 0.490197 24.678 -10.7229 -663 2 46.0672 34.0096 38.7198 -38.9175 -0.700818 10.3629 -664 2 46.8744 32.685 38.9073 -3.26917 9.79703 -36.9848 -665 1 47.7628 32.6295 40.0786 -15.9706 28.2316 14.6984 -666 2 48.51 31.5331 40.3435 -4.63001 14.745 41.8738 -667 1 48.7312 30.5422 39.5064 -7.34995 -4.23697 -9.55446 -668 1 48.9018 31.3819 41.635 -19.9532 28.2508 -37.0556 -669 4 47.1729 34.8887 37.0027 6.80802 -10.5296 7.48075 -670 4 45.9076 35.9114 37.5121 1.10402 -9.8189 16.5264 -671 4 45.0997 33.7597 38.1755 17.1722 -3.36537 -3.11703 -672 4 45.6001 34.3514 39.6854 13.8349 -0.884929 -1.62484 -673 4 47.4022 32.4647 37.9216 2.87405 7.70981 18.3952 -674 4 46.1271 31.862 38.9206 0.553217 -4.0431 12.8995 -675 4 47.6279 33.4362 40.8042 9.43822 -37.2826 -24.9694 -676 4 48.3342 30.5657 38.5603 0.826291 -3.97588 -2.82687 -677 4 49.185 29.675 39.7859 6.04467 -9.07236 4.91997 -678 4 48.5432 32.0104 0.443983 -2.47374 7.53927 7.97734 -679 4 49.3442 30.5519 41.958 17.8055 -32.7958 11.0172 -680 1 49.7507 37.2761 38.36 -27.9891 3.94923 -10.3626 -681 2 50.6372 38.1716 37.6465 6.90802 9.01894 -16.7299 -682 2 51.1009 37.4739 36.3314 6.00851 -0.000986305 0.302592 -683 3 51.4496 36.2941 36.3505 -3.04594 -4.29189 2.8804 -684 4 50.1774 36.6397 39.0138 14.1864 -12.0724 14.4781 -685 4 50.0595 39.0583 37.2837 -1.51256 1.6517 8.14679 -686 2 51.8464 38.6091 38.5553 2.49074 0.426256 -22.3009 -687 2 51.5192 39.49 39.8069 -13.5557 -5.73698 -8.16935 -688 2 52.7888 39.6608 40.6664 -21 22.821 44.9745 -689 2 51.0354 40.8913 39.3667 -19.684 19.0705 -14.0846 -690 4 52.5817 39.1556 37.8894 -7.88883 -2.40182 8.97054 -691 4 52.3725 37.6699 38.8321 2.26719 1.04002 8.03718 -692 4 50.6848 39.0041 40.3963 9.50705 2.70236 -0.692257 -693 4 52.9505 38.8088 41.3668 0.716139 -3.31122 -6.89789 -694 4 52.7117 40.5855 41.3722 -1.5977 -23.2904 -18.3054 -695 4 53.6872 39.819 40.0903 21.6097 1.4026 -14.7648 -696 4 51.7777 41.4333 38.7338 5.73144 0.910017 10.7761 -697 4 50.6933 41.5309 40.2327 12.7628 -5.43827 -4.45399 -698 4 50.1361 40.9136 38.7005 3.06807 -14.6998 5.44273 -699 1 51.1637 38.2069 35.1833 -8.65277 46.2898 44.1617 -700 2 51.553 37.7419 33.8846 1.56046 15.8517 -26.9219 -701 2 52.7972 38.5563 33.3946 6.24297 -42.3048 -4.64985 -702 3 52.8896 39.7642 33.5814 -6.435 17.9384 2.35192 -703 4 50.9569 39.2647 35.262 8.21378 -41.2603 -12.3383 -704 4 51.8027 36.6701 33.8819 4.46523 -10.0245 6.73196 -705 2 50.2986 37.9511 32.9329 -9.17145 -5.64023 18.3882 -706 2 49.0629 37.0889 33.4059 8.5101 -2.50878 -15.0431 -707 2 50.6601 37.6697 31.4816 -9.00198 -6.28682 -34.5666 -708 2 49.2037 35.5513 33.2317 13.0867 -6.63955 11.9256 -709 4 49.9372 39.0006 33.0238 8.27291 6.69816 -3.39278 -710 4 48.1686 37.4323 32.8001 8.11156 -5.69031 9.58675 -711 4 48.8477 37.3684 34.464 -5.28515 -5.82898 -0.156702 -712 4 49.7508 37.5287 30.8047 12.011 -0.0430796 16.0089 -713 4 51.2928 36.7446 31.376 -4.11156 8.47591 0.32382 -714 4 51.1768 38.5507 31.0175 4.51478 -6.96789 5.36543 -715 4 50.1453 35.1216 33.7014 -11.0082 12.206 -5.4516 -716 4 49.2178 35.23 32.1578 -3.59036 3.22922 4.55632 -717 4 48.3665 35.0295 33.7638 0.68062 2.42879 -7.65558 -718 1 53.772 37.8505 32.7005 11.9802 38.3584 -9.99311 -719 2 54.8892 38.4918 31.9453 -18.9337 33.3604 36.4373 -720 2 0.0457823 37.9282 30.5422 -8.24024 2.92716 -24.5162 -721 3 0.594264 36.8423 30.3259 -11.3073 1.50903 5.31397 -722 4 53.7906 36.8495 32.616 -6.44893 -30.0966 2.1434 -723 4 54.5933 39.6185 31.9763 4.67753 -27.1194 -20.6963 -724 2 1.30394 38.4484 32.6241 4.82921 -5.73508 14.5601 -725 2 2.2605 39.423 31.9346 -38.1373 19.2777 23.8899 -726 2 1.83713 40.7771 31.9484 17.1926 2.24265 -1.86924 -727 2 3.4991 39.1266 31.4137 44.2785 -3.28979 -22.8275 -728 2 2.64242 41.8019 31.4282 -29.5168 1.86603 13.0701 -729 2 4.3212 40.1796 30.8558 3.27898 -39.2743 8.81887 -730 2 3.87185 41.4777 30.8782 6.24363 43.3598 -8.15054 -731 4 1.73925 37.4095 32.5315 -6.00214 7.91305 5.68876 -732 4 1.22265 38.7505 33.7444 5.52003 -9.57077 -28.715 -733 4 0.900292 41.0813 32.4345 -2.25415 1.01323 1.36593 -734 4 3.85804 38.0586 31.4239 -1.87041 17.6471 -1.97414 -735 4 2.21075 0.929728 31.5263 16.6224 -11.4708 -8.14622 -736 4 5.34427 40.0148 30.4252 -14.7168 -7.47964 5.81345 -737 4 4.49601 0.410438 30.4759 -4.95559 -13.7664 3.94973 -738 1 54.5157 38.6773 29.5249 -27.0888 35.6462 7.20647 -739 2 54.4663 38.361 28.1069 5.2815 -2.56059 -27.0064 -740 2 53.8105 37.007 27.8285 4.1142 -30.4598 -15.4676 -741 3 54.2925 36.1623 27.0158 -8.84 24.3654 24.6709 -742 4 54.0165 39.6075 29.7175 18.6271 -30.7219 2.56864 -743 4 53.83 39.1099 27.5328 0.819814 -7.88342 20.1611 -744 2 0.845681 38.4599 27.4009 -3.37868 13.1124 0.920574 -745 4 1.3644 39.4179 27.7359 0.635395 -16.0183 -8.53916 -746 4 0.720089 38.4757 26.2839 -0.330424 7.67272 7.0695 -747 4 1.43916 37.5478 27.5772 11.0328 -1.07232 10.5421 -748 1 52.6562 36.7643 28.4919 4.43857 42.1876 29.7882 -749 2 51.8688 35.5726 28.5678 11.3762 10.3615 -9.24037 -750 2 52.1836 34.677 29.7554 -56.6515 -45.7393 26.8579 -751 3 51.2796 33.8674 30.1477 33.9368 21.5747 -13.7315 -752 4 52.2409 37.5914 29.034 7.3769 -32.5773 -16.326 -753 4 50.8037 35.9045 28.6197 0.824464 -11.9292 4.40922 -754 4 51.9818 34.9789 27.6186 -1.74208 2.17118 9.08886 -755 1 53.386 34.609 30.3327 15.9463 0.295407 3.2668 -756 2 53.8702 33.5918 31.2906 -5.336 7.3854 -1.97925 -757 2 53.2724 33.784 32.6972 3.62039 -3.18208 -20.5224 -758 3 53.318 34.8834 33.2435 -3.37109 6.20646 2.08258 -759 4 54.0584 35.341 30.1321 12.3398 9.17802 -3.54281 -760 4 53.5469 32.5903 30.928 0.510164 -2.93777 -2.78072 -761 2 0.450375 33.6574 31.3834 -19.8167 20.6669 9.28695 -762 2 1.1189 33.1041 30.1021 -5.33927 -7.82927 4.13606 -763 2 2.62926 33.3565 30.0201 27.5042 -3.46073 -5.185 -764 2 3.52676 32.4236 30.898 -7.76336 10.6891 3.26174 -765 1 4.93921 32.7908 30.8651 -15.3408 -23.1293 6.29736 -766 4 0.715906 33.1135 32.3077 13.219 -7.49284 0.339296 -767 4 0.711888 34.7596 31.5921 3.25804 -21.2431 -6.20467 -768 4 0.610971 33.6189 29.2485 6.53106 -4.93764 -4.86032 -769 4 0.94328 31.9817 29.9891 -3.372 16.4508 0.497364 -770 4 2.92569 34.3879 30.2717 -10.3735 11.8265 3.32189 -771 4 2.96748 33.277 28.9434 -5.36763 -4.46501 9.75656 -772 4 3.3856 31.3899 30.5364 6.91643 -9.08032 2.48396 -773 4 3.23325 32.4634 31.9813 -4.58699 -1.94284 -9.93441 -774 4 5.35439 32.7181 29.9584 6.30767 5.94328 -10.9381 -775 4 5.52691 32.2429 31.4849 -0.455553 -3.36681 1.56927 -776 4 5.05493 33.7218 31.1915 7.72328 25.1707 0.250012 -777 1 52.7526 32.6794 33.2917 -1.1678 -10.0217 7.16811 -778 2 52.3607 32.6823 34.7156 1.10255 -1.80451 -46.4405 -779 2 53.6298 32.9771 35.466 24.3124 -3.86391 3.03884 -780 3 54.7252 32.4235 35.2212 -23.0397 10.722 4.71956 -781 4 52.6718 31.7771 32.7765 -0.499018 10.5241 3.64804 -782 4 51.648 33.5318 34.8013 -6.43996 -0.39665 8.9378 -783 2 51.7643 31.3153 35.1205 -14.6608 -0.598675 31.299 -784 2 50.4472 31.4454 35.9643 8.77941 -15.5352 -26.1807 -785 2 50.5832 31.9625 37.3651 -2.67912 16.3525 37.5763 -786 3 49.9209 32.9494 37.7433 9.07957 -2.58057 -6.15032 -787 1 51.437 31.3297 38.2211 2.67596 1.57171 0.930055 -788 4 52.5216 30.7277 35.7054 -4.20254 0.0350677 -4.46682 -789 4 51.4878 30.6783 34.2719 3.29993 -4.42069 -15.0162 -790 4 49.9434 30.4567 35.9623 3.78404 -4.63917 10.5702 -791 4 49.6858 32.0412 35.427 2.21977 11.0074 -1.38139 -792 4 51.8063 30.3924 37.9705 2.16328 6.00798 1.3625 -793 4 51.6437 31.7399 39.1747 -6.68696 -10.5036 -22.3596 -794 1 53.5095 33.8962 36.42 -8.20166 25.4414 22.1973 -795 2 54.5747 34.3024 37.3295 -19.3274 -47.2338 19.7644 -796 2 54.3374 33.5175 38.6424 -52.3016 59.5202 -10.0971 -797 3 53.3688 33.7998 39.3891 18.863 -9.21915 -6.06634 -798 4 52.6243 34.4292 36.5865 8.7567 -9.68897 -5.69769 -799 4 0.524888 33.8606 36.995 20.2449 10.0463 -17.6441 -800 2 54.6326 35.7977 37.4305 -12.9517 47.1344 28.5316 -801 2 0.0326923 36.4499 36.0829 -2.43572 -2.53932 -10.8482 -802 2 0.0400304 37.9734 36.2703 -35.7369 26.7596 -9.32276 -803 2 1.42323 35.9178 35.6511 7.48175 21.564 37.2538 -804 4 0.37702 36.205 38.1946 -7.23177 -18.0499 -4.52301 -805 4 53.6103 36.1739 37.8346 22.3749 -7.86488 -15.795 -806 4 54.308 36.1878 35.2646 -5.73883 1.17112 4.65385 -807 4 54.1487 38.389 36.8719 12.989 -15.5349 -14.8375 -808 4 55.0091 38.5546 35.2982 1.66458 -12.2972 11.8538 -809 4 0.898146 38.314 36.8215 26.4509 7.27198 12.604 -810 4 1.38795 34.9003 35.2548 1.76467 -17.1685 3.06812 -811 4 2.15782 36.0461 36.5409 -11.2535 -11.763 -23.0993 -812 4 1.84494 36.4876 34.8385 7.70144 16.3511 -18.9114 -813 1 0.00368541 32.3928 38.6933 60.3495 -72.1401 -12.2197 -814 2 54.849 31.2911 39.6724 -12.054 11.0917 -33.5573 -815 2 0.456178 31.7903 40.9874 10.6429 2.84259 -7.8967 -816 3 1.61925 32.1816 41.0469 -1.25889 2.69502 -0.320895 -817 4 0.771148 32.2113 37.9508 -27.5595 2.34137 31.2634 -818 4 53.7516 31.0568 39.7052 4.35339 2.80588 13.4321 -819 2 0.572301 30.0297 39.0906 18.5839 -9.3637 1.30639 -820 2 0.330271 28.7129 39.848 -4.85336 -14.889 23.6916 -821 2 0.693398 28.6486 41.365 -25.7394 -2.5332 -16.7842 -822 3 54.7394 28.745 0.295995 1.88939 6.38348 7.55667 -823 3 1.88537 28.4667 41.718 12.1129 0.623711 3.73015 -824 4 1.68124 30.2872 39.0755 -12.926 -11.288 -1.20667 -825 4 0.269733 29.7427 38.025 4.32739 20.9521 12.5377 -826 4 0.909417 27.8521 39.409 -5.73579 9.2082 -7.491 -827 4 54.2152 28.4395 39.7334 16.9231 1.48772 2.1114 -828 1 54.6305 31.7883 0.132952 22.8608 6.07746 39.2243 -829 2 54.8576 32.3299 1.48573 -29.3221 31.1311 -21.4901 -830 2 1.17253 32.0229 2.2009 17.6366 -16.111 10.5973 -831 3 1.59057 32.8071 3.07156 -0.674056 0.0659302 -13.788 -832 4 53.659 31.6017 41.9208 -28.5726 -8.3455 -12.917 -833 4 54.8441 33.4787 1.30532 5.06012 -29.8204 14.0187 -834 2 53.6539 32.0394 2.47663 -0.820586 10.1398 -23.6755 -835 2 52.2239 32.3686 2.01123 21.8921 -9.62397 -13.268 -836 3 51.4302 33.0165 2.73635 3.85378 3.64717 10.9914 -837 3 51.8951 32.0293 0.84168 -3.94391 -2.23918 -4.0609 -838 4 53.7898 32.6162 3.39279 8.30271 4.42614 18.4259 -839 4 53.7249 30.9715 2.71423 -6.48233 -12.4206 11.3701 -840 1 1.80027 30.8157 2.00429 -3.41308 17.021 -11.1273 -841 2 3.01391 30.3872 2.67306 -17.4243 6.23421 51.1709 -842 2 4.3573 30.5827 2.00701 -14.1548 15.4243 -63.5733 -843 3 5.42088 30.6338 2.61698 6.51202 -0.211014 15.7475 -844 4 1.38736 30.0831 1.41283 -0.948729 3.54349 -2.60962 -845 4 3.08525 30.9412 3.69277 -1.85342 -9.762 -26.0847 -846 4 2.85031 29.3254 2.98975 11.9317 8.24793 -5.27874 -847 1 4.28888 30.743 0.620497 -12.3621 7.32386 22.4338 -848 2 5.32937 31.2764 41.6512 -13.8663 -29.5394 -9.66616 -849 2 5.57121 32.722 0.10225 -38.3787 16.5244 28.1783 -850 3 4.67744 33.4061 0.685107 26.0808 -18.0695 -15.0621 -851 4 3.36015 30.6914 0.159011 7.3551 0.286523 4.85155 -852 4 6.25759 30.6643 41.7722 1.97617 9.44883 5.82281 -853 2 4.84937 31.1813 40.1487 29.2597 0.863212 8.06821 -854 2 4.69879 29.8019 39.4857 10.4894 -21.0831 -13.1113 -855 2 5.6473 28.6668 39.9936 -13.3021 -14.9024 -16.8737 -856 1 5.27077 28.179 41.3306 -2.96519 4.49812 -11.7353 -857 2 6.06985 28.0105 0.470368 18.4061 -2.74343 27.4639 -858 1 7.404 28.2193 0.415809 -33.9112 -6.97322 0.0250223 -859 1 5.53751 27.6715 1.66745 7.41355 -4.5447 5.6764 -860 4 5.59287 31.7875 39.5584 -6.62026 -5.01092 -0.797873 -861 4 3.90042 31.6963 40.0361 -18.37 16.2558 -2.13315 -862 4 4.87993 29.9347 38.3602 -5.0628 -2.10161 17.6043 -863 4 3.66163 29.4121 39.5629 -5.01534 4.60088 1.06729 -864 4 6.67981 29.0441 39.9161 8.56645 -0.645935 3.00783 -865 4 5.57604 27.7587 39.2774 2.4211 23.1794 17.5601 -866 4 4.26853 28.0084 41.463 -5.17362 0.488763 -0.181308 -867 4 7.82192 28.2777 41.397 19.0269 3.46358 -1.03101 -868 4 7.9555 28.2212 1.28205 9.21585 -1.90571 -0.36079 -869 4 4.50489 27.4888 1.75639 19.7441 2.64647 4.92685 -870 4 6.15841 27.5559 2.53009 -21.7479 0.642981 -21.0512 -871 1 6.76075 33.214 41.6912 19.219 -12.8447 -16.8584 -872 2 7.12868 34.5749 41.8436 1.78261 35.3429 43.0116 -873 2 6.77609 35.3298 40.5962 -19.1975 -45.9981 -46.2181 -874 3 6.48326 34.7082 39.534 6.6414 26.9902 28.4778 -875 4 7.37626 32.7254 41.0127 -5.73863 2.32833 8.30529 -876 4 6.55071 35.0559 0.812315 8.37617 -12.7412 -20.2377 -877 2 8.6392 34.7953 0.238234 19.5739 7.90851 -48.6006 -878 3 9.35353 34.1854 41.0304 -12.8386 -4.95727 8.3137 -879 2 9.11551 34.1669 1.50873 -18.8724 -23.6236 42.9663 -880 4 8.9088 35.8955 0.234805 -6.25165 -9.40588 3.92441 -881 4 10.2786 34.3917 40.988 -0.40493 9.85267 11.4657 -882 4 10.1184 34.4515 1.79035 25.1513 6.04912 0.147779 -883 4 9.07131 33.0605 1.52977 2.37755 -2.72972 -9.56943 -884 4 8.50911 34.4369 2.41136 -0.948376 7.25744 -9.18832 -885 1 6.94474 36.6394 40.6556 -2.44135 26.6434 -23.8261 -886 2 6.9184 37.5467 39.5347 6.69905 -14.1713 -12.8446 -887 2 8.05389 37.1964 38.5245 -27.4859 18.9986 34.7956 -888 3 7.86013 37.2053 37.325 -9.29767 -2.30205 -27.2404 -889 4 7.0965 37.1097 41.5252 4.96112 6.67936 34.6112 -890 4 5.99819 37.3272 38.9586 -4.63141 4.06603 -3.57729 -891 2 6.96111 39.0217 40.0249 7.60343 4.99798 32.9439 -892 2 5.64771 39.5459 40.7503 13.3303 -11.7686 1.87571 -893 2 5.75985 41.0532 41.0609 20.2812 5.99168 -41.4278 -894 2 4.32816 39.2726 39.9704 18.565 3.35099 -29.4893 -895 4 7.21258 39.6788 39.2071 1.58444 12.8598 -26.2647 -896 4 7.87294 39.1662 40.7418 -24.807 -6.41168 -15.2883 -897 4 5.6203 39.0148 41.7319 -7.34537 -3.15131 1.25362 -898 4 4.91646 41.4032 41.6252 -26.0876 7.76092 9.54018 -899 4 5.84653 41.6805 40.0749 -1.44823 -14.0856 28.5036 -900 4 6.60816 41.2866 41.7276 9.52725 -0.69638 -3.08419 -901 4 4.29893 39.8385 38.99 0.215491 -3.12837 12.3269 -902 4 3.42741 39.5069 40.5265 -12.1672 8.54215 8.82184 -903 4 4.17367 38.2217 39.6869 7.24572 -5.84244 0.858739 -904 1 9.22626 36.8637 39.0427 21.4973 3.37181 48.1033 -905 2 10.3674 36.5714 38.2232 -9.10154 -9.23991 0.387697 -906 2 10.2983 35.2598 37.4643 -7.87493 -21.516 -1.82692 -907 3 11.0121 35.0941 36.4546 -10.096 5.18496 3.08952 -908 4 9.43559 37.0753 40.0799 -6.60045 -9.32212 -38.2223 -909 4 10.38 37.3229 37.4195 5.65865 10.6121 -8.5187 -910 2 11.637 36.6734 39.0312 17.5501 -7.37692 6.57672 -911 3 11.6795 35.7227 40.1079 -2.8679 20.1807 -0.19791 -912 4 11.748 37.6704 39.4409 -4.03165 17.0402 13.6797 -913 4 12.5247 36.6276 38.381 6.78129 -14.3562 -2.26856 -914 4 12.1944 34.9922 39.8075 10.5839 -13.8343 -8.97123 -915 1 9.37599 34.317 37.8723 17.0981 22.6825 36.4547 -916 2 9.03961 33.1663 37.0884 -21.5177 -32.5135 -8.8238 -917 2 8.42186 33.6216 35.772 12.1136 -61.8885 -37.6156 -918 3 8.46238 32.81 34.7849 1.32901 29.1307 35.9822 -919 4 8.95542 34.3811 38.853 10.4706 -4.46378 -29.0763 -920 4 9.93142 32.5518 36.7616 2.79547 16.9463 9.21372 -921 2 8.03197 32.1466 37.7484 3.42637 10.6841 -18.9321 -922 2 8.64707 31.2467 38.7916 -6.9544 1.67927 -4.64681 -923 3 8.29676 31.4213 39.9815 6.74685 -6.11142 9.13282 -924 3 9.44706 30.3423 38.4151 3.7337 3.36295 -6.87259 -925 4 7.50152 31.5448 36.9637 8.39997 -2.11551 6.41653 -926 4 7.19405 32.7023 38.1775 -8.25993 10.1263 10.5291 -927 1 7.75009 34.762 35.719 -22.4701 19.7147 -23.1057 -928 2 7.04455 35.3131 34.5484 -10.1936 -29.3849 23.8741 -929 2 7.86233 36.3488 33.8376 -13.0656 11.1044 -41.9487 -930 3 7.58485 36.6599 32.6528 -2.0293 -9.17756 21.4272 -931 4 7.63327 35.3235 36.5488 -2.91413 9.03335 17.0933 -932 4 6.86396 34.4501 33.8456 12.5342 10.3996 -5.08052 -933 2 5.61426 35.844 34.9306 19.6262 -1.52617 -28.8748 -934 2 4.83213 34.6653 35.4025 -10.2806 -24.7237 17.6593 -935 2 4.57558 34.457 36.7787 11.017 23.715 -9.65022 -936 2 4.42364 33.669 34.4835 -0.204454 17.9401 5.69744 -937 2 3.80293 33.3928 37.1817 -18.0339 -16.5573 23.9014 -938 2 3.6203 32.6104 34.8697 -1.59657 -1.57291 16.7967 -939 2 3.28719 32.4878 36.2185 14.3191 25.239 16.785 -940 3 2.42643 31.5967 36.7004 -21.786 -29.0921 6.36516 -941 4 5.08947 36.2348 33.9913 8.47084 3.13833 18.0937 -942 4 5.68856 36.6154 35.7126 -3.45102 11.3715 1.65586 -943 4 4.93536 35.177 37.5545 -2.85956 -5.82375 -8.46254 -944 4 4.68581 33.7849 33.4351 -1.13786 -0.0334624 -10.731 -945 4 3.5508 33.3312 38.3093 3.7661 -3.16504 -32.8067 -946 4 3.21561 31.8879 34.1609 -1.14089 -4.88721 -7.16666 -947 4 2.07822 31.0058 36.0335 4.80509 5.07869 -1.12919 -948 1 8.89276 36.9109 34.4697 3.08208 2.61779 2.42454 -949 2 9.71554 37.9518 33.9536 6.78836 41.9101 -7.41895 -950 2 8.87118 39.1918 33.5791 -2.83098 -3.29658 16.5328 -951 3 9.07345 39.7706 32.5156 6.00915 0.294316 2.75033 -952 4 9.0886 36.6939 35.4314 3.3626 -5.13227 22.9354 -953 4 10.4005 38.393 34.7625 -11.752 -18.5108 -5.62727 -954 2 10.5665 37.5273 32.7526 17.9231 -22.0125 -23.4044 -955 2 11.7038 38.502 32.4536 -20.96 9.74481 -37.2535 -956 3 11.6878 39.1949 31.3977 0.540028 -8.54016 25.273 -957 1 12.687 38.5377 33.3475 38.0496 20.2334 23.5086 -958 4 9.97947 37.4403 31.7814 1.01798 2.165 18.3599 -959 4 11.0193 36.505 32.8955 -2.74071 8.1052 0.988861 -960 4 12.6531 37.864 34.1655 7.32082 17.5294 -13.3715 -961 4 13.4532 39.3055 33.2787 -30.6572 -33.7139 4.421 -962 1 7.93658 39.5767 34.4996 32.6534 -23.6413 -9.43678 -963 2 7.20273 40.8089 34.5743 -2.74612 21.1773 -15.346 -964 2 8.21766 41.8982 34.9197 -3.45605 -13.7782 10.2915 -965 3 8.98784 41.7778 35.8832 -3.40272 -3.46005 -6.10842 -966 4 7.93188 38.9898 35.3424 -7.46187 6.56739 7.86278 -967 4 6.79415 41.087 33.5295 1.97546 -9.26453 20.6229 -968 2 6.06472 40.6271 35.6481 -5.08297 -2.08213 -22.9213 -969 2 4.90833 39.9858 34.8157 -12.6977 -10.7104 -3.72739 -970 2 5.64222 41.9226 36.403 -2.05312 -2.0705 -19.9517 -971 2 3.84054 39.2603 35.6406 -0.0147652 -3.33058 30.6695 -972 4 6.3943 39.8459 36.3734 2.85979 7.06395 10.3389 -973 4 5.33061 39.1839 34.1245 -4.62997 12.2623 4.99778 -974 4 4.37584 40.73 34.1591 8.26763 -2.20969 2.2716 -975 4 4.92993 41.6478 37.2106 -0.0042749 6.0371 4.19307 -976 4 5.15795 0.778755 35.7389 -1.27911 -10.984 2.34352 -977 4 6.51935 0.549814 36.8166 0.412823 -4.00159 10.9885 -978 4 3.21428 39.9846 36.2492 8.55414 -9.22464 -7.99451 -979 4 4.28582 38.4972 36.3757 -6.36125 15.4526 -14.7269 -980 4 3.14756 38.696 34.9847 -1.95473 -0.292674 -1.44435 -981 1 8.25206 1.08297 34.1638 31.3741 38.5442 9.59718 -982 2 9.18814 2.19093 34.4552 -11.7272 -14.356 -0.722089 -983 2 8.45749 3.48131 34.8023 4.76941 7.21795 3.77261 -984 3 7.24176 3.59586 34.6101 4.23254 1.41941 3.46139 -985 4 7.75397 1.25241 33.3001 -16.6469 -12.6897 -14.3012 -986 4 9.75614 1.90919 35.3591 7.11639 4.99627 7.91164 -987 2 10.1452 2.40125 33.2642 -9.36205 3.53781 1.41258 -988 2 11.145 1.26701 33.0621 15.3724 -18.5317 -10.2549 -989 2 12.3408 1.2215 34.0193 -34.6799 -20.8737 -4.25674 -990 3 13.4283 1.6066 33.6334 28.2263 9.73281 -4.88467 -991 1 12.1185 0.540183 35.1633 28.8031 2.35628 29.4382 -992 4 10.7148 3.34616 33.3936 1.59432 0.534457 -2.79864 -993 4 9.49714 2.55965 32.3759 6.01649 -0.268224 -5.10448 -994 4 11.6127 1.34439 32.0577 -0.769775 9.57011 -1.56393 -995 4 10.6933 0.251936 32.9886 -5.52334 3.35231 7.85959 -996 4 11.2139 0.219277 35.5156 -12.526 -0.0546681 -6.86711 -997 4 12.9016 0.455342 35.8573 -9.00019 3.15098 -17.6728 -998 1 9.24699 4.48326 35.2867 7.50516 -22.9453 -9.87373 -999 2 8.79457 5.81029 35.6553 19.4094 -0.44208 23.4194 -1000 2 7.94193 6.35186 34.5098 -28.0836 13.7832 22.6841 -1001 3 8.26577 6.15625 33.3485 3.32417 -1.59684 -17.5239 -1002 4 10.2626 4.25405 35.3107 -8.01304 16.2193 5.9612 -1003 4 8.1894 5.68577 36.5846 -11.6257 -0.00282829 -7.04897 -1004 2 9.97767 6.74716 36.1433 -23.7266 14.1696 -20.2452 -1005 2 11.1395 6.93836 35.1562 2.17384 -4.68321 -25.171 -1006 2 12.442 7.40754 35.8023 6.89417 23.6707 25.6501 -1007 2 12.3585 8.87197 36.3546 -17.7601 7.18701 6.16378 -1008 1 13.652 9.40345 36.7619 -5.05233 -10.0697 25.3038 -1009 4 10.4674 6.41708 37.0624 -6.17454 -12.8958 16.6295 -1010 4 9.46609 7.72624 36.4439 19.6997 -12.4825 -9.52898 -1011 4 10.8586 7.67723 34.3661 -2.31205 -2.27426 2.47252 -1012 4 11.3956 5.98923 34.5935 -8.15618 9.36142 7.97067 -1013 4 13.285 7.3766 35.0989 4.02069 -2.74272 -14.2107 -1014 4 12.7725 6.74228 36.6382 -4.94702 -0.810609 -4.3443 -1015 4 11.6162 8.97546 37.2517 21.5709 -5.37851 -23.6156 -1016 4 11.9848 9.59279 35.5592 1.32622 -13.234 7.43529 -1017 4 13.5097 10.3531 37.0548 1.1249 12.5728 4.15723 -1018 4 14.3076 9.4933 35.9914 2.38442 -5.54985 1.16984 -1019 4 14.0989 8.9471 37.5942 -8.28554 10.0467 -28.7492 -1020 1 6.74258 6.95961 34.8453 13.8439 -7.08515 -31.5666 -1021 2 5.70412 7.47847 33.9372 22.4359 17.1833 28.8896 -1022 2 4.73468 6.47268 33.3926 -37.2702 -51.3286 -21.7325 -1023 3 3.66084 6.82477 32.8505 20.0183 9.28716 8.38675 -1024 4 6.50761 7.12516 35.8163 -0.959582 1.3178 20.8718 -1025 4 5.07512 8.17388 34.5809 1.06569 -12.1955 -8.24357 -1026 2 6.27511 8.35576 32.8097 23.4106 2.51452 -13.5767 -1027 2 6.97942 9.67377 33.2004 -16.9954 14.0421 10.4255 -1028 2 6.10535 10.8129 33.826 12.866 -26.3315 -27.4761 -1029 3 5.32563 11.4369 33.048 -2.57309 4.89094 -0.177716 -1030 3 6.28787 11.1355 35.0235 5.56298 3.82152 16.5631 -1031 4 5.49496 8.55729 32.0786 -16.2509 9.70978 -5.42728 -1032 4 7.00993 7.79082 32.1666 -6.62982 -1.98309 13.432 -1033 4 7.44051 10.1227 32.2823 5.63402 -3.39012 2.91122 -1034 4 7.79617 9.4262 33.9151 4.88029 0.56984 -5.69246 -1035 1 4.9985 5.11713 33.407 24.659 21.8647 21.6253 -1036 2 4.05493 4.11234 32.9569 -19.5991 11.2557 -30.6753 -1037 2 2.66349 4.36425 33.564 5.77052 11.5327 33.941 -1038 3 2.61183 4.63212 34.7889 -10.6254 -2.1096 -24.9185 -1039 4 5.90798 4.72579 33.7623 -18.8375 16.0079 -6.75199 -1040 4 3.94963 4.2178 31.8123 4.18537 -9.18741 21.4869 -1041 2 4.52113 2.73738 33.4375 8.25229 -17.2331 29.0433 -1042 3 5.75234 2.38881 32.7881 -21.5054 -2.62865 -12.7372 -1043 4 3.76903 1.95227 33.2696 -3.85539 -5.9091 -13.5606 -1044 4 4.62925 2.69715 34.589 6.20333 6.93314 -25.3828 -1045 4 6.43526 2.61043 33.3995 7.46021 4.72267 11.925 -1046 1 1.55191 4.21884 32.8032 -14.0425 -5.15851 -21.6842 -1047 2 0.161375 4.25438 33.2368 -9.40026 13.4655 23.096 -1048 2 54.692 2.80115 33.3646 18.1492 -1.83923 -37.1888 -1049 3 54.7885 2.04564 32.3679 -9.76904 2.34815 11.9713 -1050 4 1.58614 3.87283 31.8209 11.2241 6.42129 12.946 -1051 4 0.0932821 4.78062 34.2407 6.57702 -9.00044 -6.29593 -1052 2 54.1421 5.03026 32.3092 -30.8516 -27.3257 32.8914 -1053 3 54.4529 6.38645 32.3432 43.6526 11.7784 12.1317 -1054 2 52.6693 5.00292 32.8811 18.0931 2.75777 -15.9968 -1055 4 54.1554 4.62002 31.3044 4.18983 -2.87474 -22.2473 -1056 4 53.8639 6.90955 31.8518 -25.2917 13.9269 -18.693 -1057 4 52.66 5.46781 33.8932 -7.48107 5.39969 -2.18241 -1058 4 52.249 3.98991 33.0062 0.231344 -5.48034 -3.27193 -1059 4 51.9963 5.5356 32.1423 1.66512 -1.40627 14.088 -1060 1 54.1705 2.41097 34.5199 1.80418 26.5965 31.5441 -1061 2 53.4771 1.1604 34.7223 -23.5881 -17.4143 30.2256 -1062 2 51.9672 1.43692 34.4286 45.4706 11.6959 19.6168 -1063 3 51.5098 2.51334 34.8139 -14.0548 -1.70012 -4.22959 -1064 4 54.1449 3.13072 35.3168 -2.84084 -28.6208 -21.3152 -1065 4 53.8073 0.317305 34.0552 7.54144 10.0832 -0.542806 -1066 2 53.6466 0.727247 36.2732 15.0023 -0.977243 -19.0787 -1067 2 0.11045 0.778115 36.8855 -3.47233 23.3808 -12.4462 -1068 2 0.174657 0.0352411 38.2454 9.71436 -6.65086 -1.81426 -1069 2 1.19132 0.222888 35.8995 6.11034 15.7938 3.95568 -1070 4 53.2393 41.6189 36.352 -4.11551 -11.0062 3.39296 -1071 4 53.0266 1.35722 36.9407 -10.5209 2.31976 -3.99924 -1072 4 0.276909 1.89779 37.0745 11.3679 -17.77 -1.06189 -1073 4 54.361 0.442618 38.9125 4.10216 -8.97134 2.26246 -1074 4 1.16474 0.174268 38.7716 -10.2453 4.64912 -5.91146 -1075 4 0.0894693 40.827 38.1128 -8.07449 10.5575 2.47406 -1076 4 2.18017 0.0911741 36.3628 0.498668 -8.86502 15.8712 -1077 4 1.51082 0.946112 35.1046 -21.6742 -5.82018 -4.77892 -1078 4 0.87048 41.1455 35.5035 3.84873 -0.316194 -7.96637 -1079 1 51.2572 0.510776 33.7869 -35.0849 -22.21 -18.422 -1080 2 49.7991 0.651464 33.5457 -7.89552 -1.42073 2.85742 -1081 2 49.1064 41.7127 34.6422 20.8091 24.7993 -30.4476 -1082 3 49.3211 40.5176 34.6928 0.936017 -16.9834 6.81615 -1083 4 51.5685 41.4333 33.6514 6.90564 11.6478 3.53197 -1084 4 49.4699 1.73569 33.6536 7.71362 -9.58165 1.5915 -1085 2 49.2914 0.124722 32.1435 -1.6477 0.542595 21.3952 -1086 2 49.5957 1.07684 31.016 -40.6033 -15.585 26.437 -1087 1 48.7294 1.99918 30.4836 -27.6566 13.4748 -4.54446 -1088 2 50.7297 1.21695 30.3262 36.7247 10.1326 -33.1818 -1089 2 49.2902 2.59089 29.4013 15.6758 12.8861 -16.3634 -1090 1 50.5605 2.13547 29.3267 -27.6128 -3.77706 23.4645 -1091 4 48.1729 41.8384 32.2733 14.3125 6.04861 -12.1255 -1092 4 49.7214 41.0254 31.9181 -0.443629 4.48635 2.11286 -1093 4 47.7408 2.2006 30.8029 20.1006 -6.4749 -2.25561 -1094 4 51.6449 0.698065 30.4056 15.084 -12.5894 5.57169 -1095 4 48.9104 3.2954 28.6425 -5.47018 -10.6135 19.6435 -1096 4 51.2563 2.40703 28.6421 12.9903 7.46191 -13.5301 -1097 1 48.3611 0.457254 35.523 -13.4783 35.8963 4.98689 -1098 2 47.6684 41.7265 36.6028 -12.609 2.82517 16.7739 -1099 2 46.2613 41.336 36.1362 14.2498 9.86212 -6.63619 -1100 3 45.3696 0.249228 35.9008 11.2544 -8.11188 8.40093 -1101 4 48.1527 1.47601 35.3837 2.04907 -15.0615 5.33592 -1102 4 48.2568 40.8085 36.8471 -2.89667 -2.02658 5.80089 -1103 2 47.5596 0.692305 37.8969 5.07609 12.8861 -15.4572 -1104 2 46.7247 0.067171 39.0652 -23.3887 -7.36646 -24.3057 -1105 2 47.033 40.4837 39.4166 -14.2982 16.8046 -18.6717 -1106 2 46.9311 0.907751 40.3269 20.2628 20.9695 31.7148 -1107 4 47.0803 1.72619 37.5586 18.4264 -28.4903 17.3716 -1108 4 48.6288 0.838001 38.2574 -15.841 5.68773 -4.62102 -1109 4 45.6307 0.107149 38.6982 15.4635 0.946246 17.2142 -1110 4 48.0197 40.3992 39.8616 17.8935 -6.94949 10.1905 -1111 4 47.0012 39.8155 38.524 1.84183 3.03864 3.36861 -1112 4 46.2605 40.0937 40.1174 3.5183 -0.242765 2.2201 -1113 4 48.0596 1.05972 40.5786 -27.9597 -7.64804 -5.61245 -1114 4 46.4366 0.492644 41.2461 4.13191 -4.52617 -8.48469 -1115 4 46.5029 1.93558 40.2678 1.33797 -2.98423 -8.86627 -1116 1 46.1363 40.0225 35.9719 -11.8784 -48.163 0.632693 -1117 2 44.9067 39.2611 35.7716 22.3959 0.0668878 -14.2888 -1118 2 44.4049 38.8629 37.1725 -35.2322 11.6067 -22.5418 -1119 3 45.1472 38.486 38.0617 14.0918 -2.68919 9.70234 -1120 4 46.908 39.3425 36.1226 1.34088 13.782 2.29065 -1121 4 44.2497 39.8817 35.1331 -17.245 4.97255 12.4072 -1122 2 45.2366 37.985 34.8925 -4.99104 -6.23114 -9.17669 -1123 2 44.0069 37.0072 34.8313 5.26574 11.342 7.98842 -1124 2 45.6195 38.3915 33.4226 -3.76358 -20.0352 6.70883 -1125 4 46.1177 37.4383 35.3134 -3.76426 -1.15462 7.05426 -1126 4 43.5316 36.9313 35.8696 0.358942 -6.34703 -24.4349 -1127 4 44.3242 35.9956 34.5249 4.20531 -7.16171 2.34616 -1128 4 43.2753 37.3126 34.0403 -3.87397 3.42825 10.5933 -1129 4 46.6384 38.8467 33.4221 -3.79452 2.69366 -2.61982 -1130 4 44.9004 39.1304 33.0043 0.823619 -0.608417 -3.73086 -1131 4 45.6564 37.4663 32.7381 0.0287792 19.4258 11.3413 -1132 1 43.0561 38.9062 37.36 16.7964 -0.846157 38.4014 -1133 2 42.4272 38.5172 38.6279 -14.5421 -18.7427 13.0828 -1134 2 41.8753 37.0763 38.5124 -8.78692 12.5845 -64.2445 -1135 3 41.466 36.6885 37.3717 6.29707 6.96761 32.6735 -1136 4 42.3774 39.0214 36.6331 -15.2734 7.16413 -28.2079 -1137 4 43.1919 38.4467 39.4108 16.1917 0.0561369 8.47296 -1138 2 41.3404 39.5151 39.1514 -18.2527 2.1619 5.40726 -1139 2 42.0205 40.8503 39.6333 -29.5812 13.2835 -20.5362 -1140 2 41.0689 0.171231 39.4112 30.2059 17.4331 -9.29433 -1141 2 42.4678 40.816 41.1078 15.9246 -23.8206 -10.1516 -1142 4 40.688 39.0893 39.9799 16.7303 0.907162 -6.07322 -1143 4 40.5588 39.6983 38.3606 15.4269 0.857054 0.728379 -1144 4 42.8535 41.0549 38.9416 17.5291 -0.3509 1.61726 -1145 4 41.6271 1.1561 39.6676 -14.9721 -22.7636 -0.520954 -1146 4 40.1564 0.111331 40.0029 -13.6089 -0.269988 10.9836 -1147 4 40.76 0.320829 38.3386 1.94315 -8.64923 8.74761 -1148 4 41.6626 40.4848 41.7802 -9.99726 5.60483 6.07701 -1149 4 42.8258 41.8281 41.4135 4.90552 -5.57863 6.49728 -1150 4 43.2679 40.0127 41.241 -4.54696 19.1865 -0.92221 -1151 1 41.8233 36.2733 39.5754 -3.61756 -11.0936 16.9633 -1152 2 41.1922 34.957 39.6399 -10.4088 -17.6704 -50.7121 -1153 2 39.8412 35.0841 40.3193 -0.437683 4.39576 10.763 -1154 3 39.8144 35.4746 41.4864 -9.76 5.96233 -2.547 -1155 4 42.2323 36.5766 40.4577 6.86651 4.46574 10.4638 -1156 4 40.9934 34.6386 38.4963 8.65196 -1.15376 42.0164 -1157 2 42.0562 33.8903 40.4247 20.8855 33.0106 -9.02378 -1158 2 41.3005 32.6543 41 38.0556 15.2529 -12.1112 -1159 2 42.2217 31.3951 41.1067 -29.8496 -30.3433 -13.4218 -1160 1 43.3285 31.549 0.111927 13.7517 39.8644 23.5527 -1161 2 44.3839 30.7268 0.286736 21.6234 19.2182 17.9174 -1162 1 44.681 29.6113 41.5428 -25.8767 -16.3024 -25.7307 -1163 1 45.3493 31.1499 1.13058 -39.3833 23.49 -6.35183 -1164 4 42.617 34.5166 41.192 -12.3652 -23.3828 3.531 -1165 4 42.8948 33.5841 39.7601 -4.64767 -6.80459 -5.17496 -1166 4 40.4819 32.4474 40.3056 -13.8786 -11.9041 -4.8646 -1167 4 40.8645 32.9834 0.0421702 -8.7777 -8.2778 13.4879 -1168 4 42.5872 31.067 40.0872 -0.36901 12.0823 9.30135 -1169 4 41.553 30.5032 41.4129 16.6518 20.7036 2.18161 -1170 4 43.3615 32.497 0.627799 -1.11121 -36.4642 -14.6418 -1171 4 44.0326 29.3067 40.7749 11.9664 -0.606259 12.9296 -1172 4 45.4908 28.9966 41.7635 -4.5997 7.04477 0.652143 -1173 4 45.2947 32.0222 1.6989 -3.32167 -9.1207 -8.17541 -1174 4 46.1369 30.5772 1.3332 29.28 -20.6173 7.21336 -1175 1 38.7318 34.7203 39.6307 -5.56998 -4.40152 -32.2775 -1176 2 37.3555 34.7738 40.1542 17.1032 1.0045 -6.37855 -1177 2 37.2353 33.667 41.1913 -33.3614 37.0741 40.0449 -1178 3 37.7005 32.5636 40.9891 18.731 -32.0974 -3.65368 -1179 4 38.8335 34.3404 38.6486 -6.51334 12.5121 23.5529 -1180 4 37.2672 35.7762 40.6273 -9.086 1.46109 5.84779 -1181 2 36.2453 34.5638 39.0845 -6.93832 -9.37108 -7.97374 -1182 2 36.1701 35.614 37.9414 8.91404 15.2365 -6.3275 -1183 2 35.3527 35.0344 36.7472 39.8054 8.21108 -27.9 -1184 2 35.4841 36.9314 38.4139 -18.287 13.7727 -16.8718 -1185 4 35.232 34.5024 39.5744 7.45292 -0.257102 0.0904576 -1186 4 36.3852 33.5433 38.6164 0.781265 7.17557 6.89015 -1187 4 37.2115 35.9047 37.5843 -11.2451 -10.8797 5.10717 -1188 4 35.5662 35.6385 35.778 -16.1675 -5.48794 25.897 -1189 4 34.291 34.967 37.0013 -15.7304 -0.876038 -4.35202 -1190 4 35.7074 34.0135 36.4456 -4.10332 3.28733 9.08934 -1191 4 35.4655 37.7439 37.5577 -4.97646 -27.0735 23.6494 -1192 4 36.0148 37.4196 39.237 12.1669 1.46201 8.99598 -1193 4 34.4369 36.7462 38.8365 16.8945 3.16641 -16.172 -1194 1 36.5334 33.9935 0.435925 10.1465 7.38421 -15.9691 -1195 2 36.4058 33.2568 1.6875 16.4821 -29.3274 -13.0782 -1196 2 35.1468 33.6833 2.42741 -3.52585 26.4938 2.22063 -1197 3 34.7699 34.8785 2.50349 9.50092 -20.8144 -9.83338 -1198 4 35.9506 34.8486 0.439937 7.33038 -6.12466 -5.51472 -1199 4 36.3499 32.1247 1.42412 1.62075 26.2077 7.36918 -1200 2 37.675 33.5505 2.58336 -0.681506 -6.35683 7.58589 -1201 2 37.7854 32.6927 3.8625 18.6921 -17.668 32.0141 -1202 2 39.0575 32.9332 4.76873 14.2724 -20.5826 -30.9069 -1203 1 39.1289 34.2491 5.33109 11.0713 19.2422 13.5273 -1204 2 40.0441 34.6938 6.2528 -38.5124 5.77538 -21.346 -1205 1 41.0523 34.0015 6.75388 -9.3068 -30.315 -40.8639 -1206 1 39.7573 35.8959 6.75045 4.65044 -37.6482 -19.533 -1207 4 37.7117 34.6025 2.94212 -4.78803 6.98284 -11.1897 -1208 4 38.6033 33.3783 1.98429 -1.50456 2.19712 -0.683264 -1209 4 37.8193 31.5994 3.65006 -4.42508 0.799529 -11.9295 -1210 4 36.9318 32.7949 4.56147 -11.5542 5.52665 -5.70323 -1211 4 39.9727 32.6563 4.13477 -10.3426 12.9457 13.0222 -1212 4 39.0991 32.232 5.62646 -6.41615 -9.9444 -1.6393 -1213 4 38.3112 34.8566 5.12728 9.08197 -0.1797 3.06874 -1214 4 41.338 33.0965 6.26824 1.29043 26.2885 21.8424 -1215 4 41.5567 34.3995 7.53172 18.6054 -2.34736 15.9895 -1216 4 38.9283 36.4191 6.51463 -17.6749 8.57537 -7.4588 -1217 4 40.3535 36.2619 7.44459 24.2502 25.7988 36.1589 -1218 1 34.4423 32.7029 2.99518 -5.91218 -18.2551 8.17758 -1219 2 33.2643 32.9205 3.78866 2.14491 3.18155 15.0212 -1220 2 32.3114 31.74 3.93685 27.6029 1.93064 -50.2862 -1221 3 31.6521 31.6162 4.95167 -20.1995 -6.42992 23.3772 -1222 4 34.7506 31.7123 2.9878 2.11082 4.57648 -1.08475 -1223 4 33.5885 33.2179 4.82725 -4.56531 -3.45872 -11.3922 -1224 4 32.6993 33.791 3.40271 -6.19117 1.50996 -1.33542 -1225 1 32.2733 30.8792 2.86255 -3.44833 -0.807911 26.2314 -1226 2 31.5067 29.6456 2.87911 -22.6819 -12.0155 6.38652 -1227 2 32.0275 28.5204 1.99364 -17.4826 -15.7648 -26.1521 -1228 3 31.24 27.9052 1.1757 18.2868 13.9435 17.0259 -1229 4 32.9257 31.0189 2.07167 -6.99587 -10.4877 -2.31778 -1230 4 31.4409 29.1882 3.92659 1.7726 14.0477 -11.6562 -1231 4 30.4172 29.8482 2.57519 20.7941 0.876843 7.98191 -1232 3 33.2432 28.1769 2.02662 6.75216 10.2675 5.6015 -1233 6 29.6689 33.0345 2.6027 6.39732 3.7635 -6.59735 -1234 4 28.7656 33.0857 2.95028 -0.371973 -14.4593 -6.85361 -1235 4 29.8153 32.1814 2.14015 -8.59972 11.6466 4.8732 -1236 6 1.91326 24.7635 28.0772 5.65317 -6.35183 16.4854 -1237 4 1.01929 24.4316 28.2568 3.94453 1.46201 -0.938269 -1238 4 2.46517 24.4471 28.8255 -6.59296 2.11781 -11.8027 -1239 6 8.98979 35.4216 7.06427 2.13264 0.908259 -3.07356 -1240 4 8.22375 36.0041 6.95701 -0.608539 -3.26387 0.365744 -1241 4 9.74616 35.991 6.87666 4.70766 2.91314 -0.442423 -1242 6 37.9357 35.2342 23.5273 -23.102 9.18642 19.8247 -1243 4 37.5041 35.2968 22.6705 0.513901 -3.82007 -8.89977 -1244 4 38.8432 35.0218 23.4038 20.8563 -8.17935 -11.4372 -1245 6 11.3793 34.6137 20.3253 14.1507 4.32837 -4.20952 -1246 4 10.4755 34.624 20.6003 -22.0831 6.77293 1.73618 -1247 4 11.7264 33.9016 20.8561 13.9299 -11.0914 4.04985 -1248 6 3.06607 13.1144 13.5167 22.577 18.8722 18.6067 -1249 4 2.20388 12.8262 13.8046 -7.02328 -4.57126 0.810516 -1250 4 3.32154 13.8092 14.1761 -2.44089 -14.0351 -15.8923 -1251 6 9.17443 22.3777 24.8954 -7.42914 3.56866 8.74917 -1252 4 9.07626 22.0242 24.0039 2.26474 -2.4656 -3.7019 -1253 4 8.26912 22.4958 25.2295 3.15193 -1.43545 -3.27774 -1254 6 31.1464 36.1236 7.45234 10.6607 -18.1227 -24.2194 -1255 4 30.9334 35.2222 7.12747 -5.34615 12.6105 12.538 -1256 4 31.8314 36.3443 6.79825 -5.43643 8.62165 8.26122 -1257 6 20.3227 0.172698 30.1419 10.3105 -3.05703 7.76208 -1258 4 20.0388 1.0684 29.8874 5.3247 -3.32009 0.781739 -1259 4 21.2583 0.228399 30.4322 -11.2768 6.47679 -5.28094 -1260 6 32.6859 3.01778 5.15829 -10.6028 -19.0303 43.6625 -1261 4 32.0356 2.3058 5.02019 7.54008 9.83835 -8.28794 -1262 4 32.7128 3.00557 6.15578 5.12118 6.62375 -23.7252 -1263 6 26.2374 8.27856 11.5971 17.869 0.788073 20.0593 -1264 4 26.2346 7.39991 12.0216 -0.142457 7.42091 -4.28305 -1265 4 26.8978 8.79254 12.1302 -17.5189 -15.6641 -18.5798 -1266 6 1.09614 20.2561 0.875192 -22.9747 0.467748 19.1373 -1267 4 0.851949 19.3199 1.10255 19.4844 20.3298 -11.3195 -1268 4 1.85437 20.3448 0.297385 12.1513 -16.76 -9.59627 -1269 6 29.1514 22.9126 1.42851 -3.57267 15.5796 12.2113 -1270 4 28.6966 23.7416 1.67141 5.52941 -12.1705 -9.88265 -1271 4 29.6634 22.7027 2.22543 0.165437 -2.26551 -2.85175 -1272 6 34.1399 34.826 6.47271 -4.00425 12.5535 -7.93856 -1273 4 34.8635 34.3401 6.10458 13.259 -3.54932 -9.87122 -1274 4 33.9387 34.3337 7.25184 -8.28913 -2.66912 16.7304 -1275 6 25.1643 37.1931 26.5228 17.2229 -22.0393 -23.1844 -1276 4 24.6935 37.7676 27.1042 -4.31343 22.2846 18.4719 -1277 4 26.0117 37.6203 26.271 -7.79876 5.52479 6.28113 -1278 6 14.5333 22.2337 15.6719 -21.8235 -40.5779 4.16881 -1279 4 14.0435 21.3187 15.7268 23.5152 50.9834 -4.51283 -1280 4 14.2451 22.7392 14.8947 -1.224 -10.8945 3.63574 -1281 6 2.86145 5.86342 4.09514 -12.0928 12.5672 -7.55007 -1282 4 3.31871 5.53612 4.87755 -0.114002 3.3263 11.1441 -1283 4 2.36891 6.69134 4.30817 11.5092 -15.7361 4.93451 -1284 6 27.6072 26.7133 22.7037 11.3111 -21.4893 35.9413 -1285 4 26.8221 26.1673 22.7712 -7.10606 -4.70529 -2.97044 -1286 4 27.5145 27.2572 21.9514 -10.0855 20.8317 -32.7258 -1287 6 17.7799 0.609907 22.4001 -5.17757 10.6635 4.04288 -1288 4 17.0763 0.657064 23.0885 11.5181 4.04392 -9.91171 -1289 4 18.0806 1.5364 22.261 -7.85301 -10.5281 2.59652 -1290 6 8.08893 9.42761 10.5595 3.55537 5.25916 40.324 -1291 4 7.89361 10.322 10.3179 -9.19974 15.7377 -19.3495 -1292 4 8.16563 9.56196 11.5399 2.2102 -21.2534 -20.7584 -1293 6 15.3508 8.71886 30.755 5.09068 -14.416 21.7005 -1294 4 15.721 8.98141 29.9127 -5.17651 10.4904 -11.2194 -1295 4 14.5411 9.19598 30.997 6.64715 3.62724 -9.30987 -1296 6 11.0273 17.2714 37.5546 -8.62993 4.63856 -3.16721 -1297 4 10.646 18.1523 37.5049 13.3861 11.3255 -4.88271 -1298 4 10.2437 16.8378 37.8681 -2.55755 -24.0409 7.53141 -1299 6 42.0954 25.1585 20.3881 14.6842 1.84925 -24.6227 -1300 4 41.6997 25.8318 19.7943 -2.16553 -3.48259 16.6789 -1301 4 41.6994 25.1952 21.2528 -9.02961 7.39914 10.888 -1302 6 25.8656 4.70522 33.8434 4.94337 -17.9304 30.0995 -1303 4 25.7948 4.41246 32.9437 -1.56424 4.53154 -20.9619 -1304 4 25.7821 5.65919 33.9019 -2.93726 10.638 -9.31877 -1305 6 28.7565 10.7943 24.343 5.31048 -5.66707 -17.5237 -1306 4 29.0395 10.691 25.2776 6.61806 -8.7001 -20.887 -1307 4 29.3174 10.2678 23.7025 -8.86987 6.64124 26.5787 -1308 6 5.00601 41.813 11.1 6.11697 -35.3303 28.6791 -1309 4 5.97939 41.6679 11.0741 -12.7816 8.03831 -2.02432 -1310 4 4.68345 41.1078 11.7429 5.5471 25.1349 -25.8779 -1311 6 51.7607 12.785 30.1531 41.9873 7.8243 6.58168 -1312 4 51.5044 13.1989 29.3224 -3.76645 3.26875 -7.63234 -1313 4 52.7548 12.9452 30.2104 -29.821 -7.22149 1.35463 -1314 6 7.60527 6.19156 6.53697 16.5093 0.883216 -0.386471 -1315 4 6.7728 6.50088 6.91441 -4.77803 -9.70632 -1.71599 -1316 4 7.48617 5.31021 6.15237 -11.2115 3.19853 1.4886 -1317 6 14.6639 26.9856 30.1439 5.75321 15.8705 11.2484 -1318 4 14.5566 27.0259 31.1175 -3.12227 -7.05885 -13.9758 -1319 4 15.1715 27.7926 29.9326 -6.11328 -7.83436 0.701957 -1320 6 15.3386 3.73742 21.1629 -49.5233 -4.42818 1.41573 -1321 4 14.7513 4.15862 21.8308 22.5595 -2.74077 -5.2282 -1322 4 14.679 3.20837 20.6508 28.7222 9.19721 3.95726 -1323 6 18.6168 30.4391 6.46727 22.6827 -23.6706 30.2016 -1324 4 19.0357 29.7477 7.08277 -19.2097 26.0479 -21.7287 -1325 4 19.3376 31.0911 6.37388 -10.7119 -2.89972 -1.77141 -1326 6 40.7683 1.30949 12.8061 -7.58564 4.37034 -9.51004 -1327 4 39.8743 1.70123 12.8539 8.02325 -2.8267 0.614513 -1328 4 41.1302 1.62292 11.9594 1.79027 -4.37486 1.66609 -1329 6 17.747 20.7401 41.5828 -14.5708 23.9699 -22.25 -1330 4 16.8287 21.1121 41.5273 18.852 -12.8662 8.2158 -1331 4 18.269 21.3043 40.983 -0.296974 -7.34806 11.4382 -1332 6 20.4522 2.1467 12.3338 -13.8993 16.4183 -18.7538 -1333 4 19.8428 1.38545 12.4588 7.32118 14.6694 -7.56396 -1334 4 20.1591 2.61844 11.4836 4.96023 -26.6086 29.2353 -1335 6 9.8437 37.1731 18.0697 32.5344 -3.69518 -7.02483 -1336 4 9.9915 37.607 18.9153 -11.6933 2.16478 7.61773 -1337 4 10.7629 37.1686 17.7045 -22.2666 -4.61022 -1.39483 -1338 6 22.8273 7.39987 18.8956 -5.5011 7.28813 -36.492 -1339 4 23.2632 7.84344 18.1165 -7.98371 -8.25387 20.5209 -1340 4 21.8866 7.2843 18.6392 14.3432 0.686453 4.84686 -1341 6 12.8601 6.85899 39.0577 6.92589 -13.3495 -12.6124 -1342 4 12.2887 7.60854 39.1608 -14.8411 14.7282 0.271429 -1343 4 13.3423 6.79713 39.8797 5.00888 -0.905409 12.2129 -1344 6 10.1643 2.40912 23.2548 -13.4149 21.1074 -1.06732 -1345 4 10.2774 2.03439 22.3894 8.18098 -13.9841 -15.6202 -1346 4 9.49692 3.09648 23.049 6.99386 -4.39158 13.7206 -1347 6 12.5495 20.2147 19.5723 7.26787 8.21028 -18.3895 -1348 4 11.6895 19.7983 19.735 -1.5185 0.18686 -8.43892 -1349 4 12.6119 20.404 18.6017 -2.05058 -6.51038 26.2392 -1350 6 53.8702 6.35891 18.9198 29.7306 -6.18586 8.10346 -1351 4 53.0457 6.06715 19.2818 -21.258 -2.7468 0.110915 -1352 4 54.4788 6.08079 19.6257 -1.29631 10.1734 -11.3531 -1353 6 1.76233 4.00968 13.2412 15.2049 -20.178 -6.82767 -1354 4 1.1126 4.5015 13.7221 -14.7745 7.27862 5.55391 -1355 4 1.46634 3.0803 13.3195 6.22895 8.64986 -3.00031 -1356 6 2.68809 16.4658 4.58471 15.0105 -8.44828 17.4213 -1357 4 3.47968 16.3912 5.17607 -18.0483 5.65918 -16.5792 -1358 4 2.952 17.0668 3.88721 1.61121 4.43717 -9.18758 -1359 6 22.6412 7.38905 35.0491 -42.342 -19.7774 -51.2585 -1360 4 21.8701 7.10292 34.411 47.7649 22.3984 34.2121 -1361 4 22.4927 6.7758 35.7601 0.300803 -9.30322 17.5195 -1362 6 30.6449 27.8966 19.9 11.2186 24.5725 -17.4668 -1363 4 31.067 28.6028 19.3405 -15.311 -24.4133 12.7333 -1364 4 30.0502 27.364 19.3383 6.18265 4.0422 4.40167 -1365 6 18.3584 9.54031 6.21119 11.0026 -3.68808 23.2716 -1366 4 18.3645 9.12256 5.3612 -2.33489 -5.22153 -19.3682 -1367 4 19.1216 9.13552 6.66909 -8.40358 6.03455 -2.63927 -1368 6 21.0207 30.3946 30.8361 -20.2261 -14.3153 8.76877 -1369 4 21.7305 31.0371 30.8947 0.539155 4.23503 10.2216 -1370 4 20.6128 30.1908 31.727 18.9681 11.2591 -24.4987 -1371 6 28.3223 4.36971 15.0862 0.785553 22.566 1.53388 -1372 4 27.9162 3.53142 15.2341 -13.4814 -22.4749 6.99245 -1373 4 29.0547 4.16931 14.5133 14.7433 -0.183871 -4.75122 -1374 6 12.7699 0.652736 16.5284 -10.9622 36.0111 -3.70833 -1375 4 13.1417 1.43405 17.0195 -7.22472 -23.339 -11.6266 -1376 4 12.1312 1.03058 15.8629 17.1298 -5.78525 17.4901 -1377 6 27.5613 35.204 8.24204 -17.5468 -3.17574 2.50179 -1378 4 28.0037 35.3359 7.41158 3.58667 2.22765 -10.9792 -1379 4 26.8513 34.5538 8.04841 12.0719 12.2779 8.55847 -1380 6 24.0727 5.16129 41.0114 25.3265 34.0312 4.62534 -1381 4 24.5764 6.00631 41.0278 8.83913 -22.6202 16.662 -1382 4 23.4512 5.41721 40.3589 -27.9927 -11.5371 -21.4854 -1383 6 16.8577 24.9409 28.3044 -13.362 20.9446 -8.34262 -1384 4 15.8529 24.9248 28.4711 42.0709 9.51562 -15.4474 -1385 4 17.0929 25.6637 27.6385 -20.1406 -20.6283 22.1367 -1386 6 20.8367 12.7872 17.016 48.1357 -13.7972 -0.957512 -1387 4 20.9831 13.7012 17.3244 -4.24853 -6.44611 -2.53838 -1388 4 21.7731 12.3998 16.8344 -46.2893 13.5674 8.59046 -1389 6 35.7698 23.0286 30.9167 1.31549 -8.15919 10.0357 -1390 4 34.8007 23.0783 30.9694 4.38358 -0.634017 0.107585 -1391 4 36.0504 22.6611 31.7855 -2.79806 7.45108 -14.1947 -1392 6 36.3049 21.4 25.8723 16.8231 15.2703 -10.059 -1393 4 35.3849 21.2313 25.7163 -23.5769 -6.11261 -4.10927 -1394 4 36.6855 20.6326 26.2849 5.24534 -13.4215 6.45433 -1395 6 13.4896 6.74946 5.28081 -28.3592 57.2786 25.4238 -1396 4 13.8414 6.02988 4.86679 44.4058 -71.9847 -33.7479 -1397 4 12.7199 6.9047 4.75258 -19.8414 9.95147 -1.72496 -1398 6 20.8046 20.4221 13.7595 5.24729 11.8597 -23.4966 -1399 4 21.3314 20.3763 14.5586 1.04488 -1.4591 8.76088 -1400 4 19.8874 20.2651 13.9627 -8.54986 -4.70556 7.47732 -1401 6 20.3763 29.1306 1.39291 -22.654 9.61717 24.1604 -1402 4 20.4714 29.8874 2.01179 2.99602 -8.49852 -9.62387 -1403 4 19.4639 28.7985 1.61052 22.0838 3.18086 -13.1329 -1404 6 50.878 13.1268 37.2744 -6.92527 18.9089 19.2141 -1405 4 51.431 12.5903 37.8743 -5.40112 9.96959 -2.47836 -1406 4 50.5327 13.8902 37.8162 10.8793 -23.2499 -13.6212 -1407 6 33.933 34.1706 20.4988 -24.935 23.2996 -4.02345 -1408 4 33.9537 34.3969 19.5503 3.97405 -5.2202 10.173 -1409 4 33.1424 34.6907 20.8306 20.6842 -17.0796 -4.50693 -1410 6 26.2139 28.0427 27.5441 -18.3219 -6.87449 2.92541 -1411 4 26.6233 28.4264 28.3298 2.52406 0.509022 -5.28732 -1412 4 25.2474 28.0355 27.7473 15.6982 -2.70826 -9.65401 -1413 6 7.68199 21.3044 4.2899 -23.4352 7.97399 30.3744 -1414 4 8.39223 20.9571 3.80392 40.3202 -21.1106 -20.5498 -1415 4 7.23721 21.8696 3.67656 -12.7303 12.1883 -10.427 -1416 6 21.997 15.1678 5.91921 0.156106 10.1967 -8.47357 -1417 4 22.4631 15.3078 5.09012 1.49736 10.8302 -2.43488 -1418 4 21.9323 14.2285 5.99467 -4.63281 -19.7734 10.7123 -1419 6 21.7161 24.0028 3.81129 14.7157 -6.77156 -2.79544 -1420 4 22.6514 24.278 3.99089 -16.266 -7.57571 -5.80044 -1421 4 21.7278 23.1773 3.27349 4.3704 10.7286 8.25651 -1422 6 11.5654 23.7677 12.5675 4.34126 23.9889 5.0328 -1423 4 11.8179 24.711 12.3772 -5.51197 -27.812 -0.203907 -1424 4 11.194 23.7871 13.4529 -2.51135 -1.17837 2.27349 -1425 6 32.365 18.0609 29.8133 5.42876 1.07285 10.0727 -1426 4 33.2855 17.8495 29.9872 2.18588 2.92383 8.75228 -1427 4 32.2516 17.686 28.9464 -9.45666 -7.03173 -17.6671 -1428 6 9.26057 12.3901 30.3108 6.69251 -5.93803 -6.45383 -1429 4 8.9331 13.0089 30.9751 -1.99931 -0.452864 0.983921 -1430 4 10.127 12.0766 30.6488 -15.6011 7.03664 -5.16285 -1431 6 40.1575 25.9297 9.14135 -21.3024 -7.39617 3.31146 -1432 4 40.7828 25.2448 9.36979 6.64832 -8.60816 0.262948 -1433 4 40.6901 26.6937 8.96671 10.3695 18.4246 -3.8085 -1434 6 43.1786 32.337 37.3292 -33.551 -18.2832 -9.28851 -1435 4 42.7165 32.8749 36.6701 14.8891 8.67062 4.46068 -1436 4 42.4294 31.7351 37.5575 24.0939 3.67107 5.33039 -1437 6 44.0961 6.28371 31.2632 9.51948 -8.69332 -33.5784 -1438 4 43.4914 6.92213 31.6058 -15.4833 19.2503 12.9198 -1439 4 44.559 5.89005 31.9835 8.76633 -8.79917 23.1113 -1440 6 10.2083 18.8859 19.6919 15.5822 -2.80816 -8.35433 -1441 4 10.2079 18.3466 20.4907 -1.18434 0.124911 0.125127 -1442 4 9.35433 19.315 19.665 -12.7717 3.54701 3.24565 -1443 6 7.05259 15.5816 15.0277 -11.6868 16.7681 -20.4125 -1444 4 7.21112 15.523 14.0697 -0.749561 -1.2692 3.08306 -1445 4 7.39122 14.7797 15.3874 7.84577 -24.8334 9.86289 -1446 6 24.5366 3.48359 27.8583 16.7503 5.69766 5.18976 -1447 4 23.7024 3.43271 28.3539 -4.73503 -2.50774 -10.2909 -1448 4 24.4259 3.10654 26.9763 -12.6917 -5.22111 2.5626 -1449 6 54.3931 31.8073 9.72289 -3.19054 17.1237 19.0803 -1450 4 53.9641 31.62 8.89214 -6.37727 -2.00813 -13.4715 -1451 4 54.1243 32.7301 9.92854 3.65429 -15.124 -2.64791 -1452 6 6.79493 17.0949 36.2025 -8.81624 7.47492 14.5397 -1453 4 5.9165 16.6466 36.2092 18.1356 5.91394 -12.2869 -1454 4 7.21103 17.1598 35.3293 -13.3551 -7.88765 -1.67162 -1455 6 28.633 7.46221 20.4165 -21.0133 14.9556 -29.8407 -1456 4 27.7506 7.6389 20.7846 4.83271 -6.12746 3.71795 -1457 4 28.5316 7.77661 19.4783 9.56717 -7.40103 22.9991 -1458 6 17.0376 1.7027 8.35788 5.34968 28.5352 32.0038 -1459 4 17.0661 0.753124 8.28199 -2.4228 -14.8367 -20.8379 -1460 4 16.762 2.22772 7.59129 -1.56258 -15.3605 -8.12812 -1461 6 19.1384 19.3343 35.5751 19.5023 3.30605 7.15282 -1462 4 18.4451 18.7061 35.4179 -10.2251 -8.92118 -4.92207 -1463 4 19.8852 18.808 35.914 -3.54436 4.66685 -0.605832 -1464 6 7.31639 31.3666 13.5695 -43.9944 -20.214 -21.2721 -1465 4 6.78612 30.574 13.8569 21.4883 17.7075 -0.698983 -1466 4 6.68503 31.7843 12.9295 22.0056 -0.349161 9.64417 -1467 6 16.674 5.24419 12.8556 -11.0373 -33.5815 5.02698 -1468 4 17.465 5.75961 12.9546 20.2971 3.5869 6.63236 -1469 4 16.7677 4.34295 13.2785 1.53127 21.9447 -10.2143 -1470 6 43.8803 12.7494 34.5747 -22.4085 -20.9808 -0.0671255 -1471 4 43.9515 13.6536 34.2548 -4.30422 8.76569 -3.51904 -1472 4 42.9542 12.429 34.42 18.6754 8.57765 -0.433924 -1473 6 42.6607 36.4569 28.5239 -16.8168 -12.4187 2.20896 -1474 4 42.172 37.2929 28.6321 13.9601 -3.78206 -4.91178 -1475 4 43.5913 36.5775 28.2923 4.62592 13.2896 -0.105187 -1476 6 35.3772 15.0586 6.04009 27.912 48.9275 -7.18458 -1477 4 35.887 15.8982 5.7897 -19.1126 -32.2788 12.1212 -1478 4 34.8045 14.9281 5.27735 -5.52923 -7.04807 -1.55591 -1479 6 19.4078 5.85855 6.1829 -40.2001 -18.9085 -3.31614 -1480 4 18.5441 5.99364 6.63156 8.43156 -9.10613 -8.3884 -1481 4 19.928 6.53616 6.54489 31.8426 31.4232 15.0663 -1482 6 29.261 38.1682 6.98131 -37.2303 32.1811 -6.57247 -1483 4 28.4837 38.0966 7.57517 15.5489 -1.40449 -6.41795 -1484 4 29.8842 37.5088 7.21603 19.671 -25.1607 10.5683 -1485 6 19.357 26.1782 8.47801 4.74765 -18.9961 17.9486 -1486 4 19.3733 25.7814 9.38274 -2.97831 10.6699 -17.265 -1487 4 20.1618 25.7953 8.09114 -4.76457 3.34604 0.730176 -1488 6 4.92328 16.6713 6.1398 7.47336 5.27851 2.26954 -1489 4 5.50113 17.3858 5.8203 -2.76896 -2.40075 1.51866 -1490 4 5.42288 15.8417 6.02573 -4.96937 12.5626 -0.560722 -1491 6 6.06184 16.6875 28.0703 25.9558 6.64688 1.10321 -1492 4 5.15824 16.4097 27.9597 -16.212 -5.66481 -14.185 -1493 4 6.48748 16.8231 27.1848 -21.9791 -6.00697 19.2504 -1494 6 21.7362 29.3702 22.1089 -17.2737 20.913 34.8846 -1495 4 21.4452 30.3289 22.1112 6.19611 -27.0689 0.469942 -1496 4 21.3293 28.9728 22.9428 14.5469 12.9694 -26.9427 -1497 6 24.4985 0.540505 12.8515 12.2489 -9.36427 2.95715 -1498 4 24.0437 0.939092 12.114 -3.50986 5.42614 -10.4761 -1499 4 24.1106 0.99496 13.5957 -0.561841 3.41965 12.163 -1500 6 18.4019 28.2584 40.3145 -11.401 19.5033 -15.6681 -1501 4 18.3886 27.6361 41.0165 -1.05122 -20.6036 22.2694 -1502 4 19.1831 28.024 39.826 8.23901 2.08545 -8.43276 -1503 6 10.3826 17.4565 21.9113 1.92941 -13.2413 3.45357 -1504 4 9.8824 16.6205 21.8349 3.82121 7.52813 2.02092 -1505 4 9.93899 17.9725 22.5913 -5.82795 2.16988 4.16556 -1506 6 13.5489 13.3588 39.6353 11.9209 29.8927 39.0415 -1507 4 13.8427 14.2544 39.3649 -8.64321 -16.3346 -3.85104 -1508 4 13.5548 13.4385 40.6332 -1.97454 -11.1079 -31.9482 -1509 6 19.5449 26.0093 24.7389 -52.2633 13.2593 -7.73686 -1510 4 19.57 25.3975 24.0097 10.2262 -10.7296 -10.4349 -1511 4 20.3304 26.0184 25.2393 35.6126 -10.3894 17.1361 -1512 6 8.93096 25.8929 20.0882 -7.71251 -64.4566 3.30388 -1513 4 8.30787 26.3938 20.5887 -11.4685 32.8171 11.63 -1514 4 9.62246 26.3511 19.648 20.7791 34.2926 -13.3665 -1515 6 13.4555 41.2072 30.5108 -10.8988 -15.928 5.69795 -1516 4 14.2767 41.1294 31.0436 -12.4449 -5.39064 -3.38157 -1517 4 12.7718 40.5451 30.8276 25.6688 18.9533 -5.69319 -1518 6 21.165 21.6707 11.1126 6.53241 11.8742 3.94385 -1519 4 20.8889 20.8699 10.6872 -6.5221 -17.8932 -11.6656 -1520 4 21.171 21.4318 12.0451 -0.673303 -0.892159 6.0991 -1521 6 43.5659 10.3222 15.565 -2.18625 -17.2881 -4.53442 -1522 4 43.269 9.50121 15.139 10.696 3.36153 7.59808 -1523 4 42.8911 10.937 15.2983 -10.0921 17.3133 -0.93945 -1524 6 23.5255 5.06673 12.3063 -8.27451 55.1521 -7.02327 -1525 4 23.4703 4.15364 12.096 -5.93718 -33.8878 -14.7403 -1526 4 23.077 5.57318 11.5535 15.1023 -26.9196 22.8331 -1527 6 9.29314 15.4001 4.25145 -3.86255 -4.02248 -25.5662 -1528 4 8.9509 16.1187 4.78154 1.1615 8.22379 13.6068 -1529 4 9.97933 14.9549 4.74249 8.84801 0.0887981 11.7331 -1530 6 26.7067 10.8779 17.5788 3.55047 -19.7627 -22.9275 -1531 4 26.5537 10.995 18.4988 -3.13636 8.79354 30.8805 -1532 4 26.79 11.729 17.1566 -1.16375 6.51516 1.16674 -1533 6 26.0497 23.6027 33.6801 19.5894 25.2732 20.1931 -1534 4 25.4452 23.9936 33.0304 1.52608 5.68176 -1.06817 -1535 4 26.6384 24.3139 34.1277 -30.0139 -24.8801 -23.6693 -1536 6 7.5709 10.5028 28.9083 -0.962228 -19.583 -21.6711 -1537 4 6.74329 10.4799 29.4005 3.80738 8.46019 8.36633 -1538 4 8.19878 11.0832 29.3397 0.629116 8.24646 12.7121 -1539 6 16.498 16.9072 24.6485 7.82025 23.6222 16.3151 -1540 4 16.0345 17.7596 24.5588 5.31695 -3.73313 -0.390286 -1541 4 16.1792 16.4208 23.9083 -7.11448 -16.9587 -21.9433 -1542 6 12.549 12.7866 0.448591 8.35618 6.39845 34.9671 -1543 4 12.9768 12.9146 1.38779 -15.5602 -17.6496 -50.0052 -1544 4 12.7689 11.9205 0.0349689 0.659473 7.36742 13.3893 -1545 6 6.80731 2.45617 9.05869 -7.23501 -7.03372 -0.578084 -1546 4 7.10343 3.02287 9.78944 7.77528 -6.31722 -2.26682 -1547 4 7.3272 1.63733 8.99034 2.01029 5.74015 6.94656 -1548 6 28.8877 11.8706 12.0154 41.6386 34.6329 -2.99516 -1549 4 28.2108 12.4771 11.6895 -6.34049 1.49886 1.56166 -1550 4 29.7533 12.3393 11.8008 -29.7579 -18.4108 8.17464 -1551 6 44.6745 32.5962 29.7139 -34.2161 4.66467 6.73964 -1552 4 43.7628 32.9784 29.4642 35.9402 -16.1761 10.2258 -1553 4 44.5125 31.9002 30.3967 -1.3182 18.2082 -15.8911 -1554 6 28.5995 15.1068 32.2872 13.2766 -51.3111 -20.1848 -1555 4 29.0279 15.8582 31.8991 2.31019 19.0875 -3.40369 -1556 4 29.0943 14.3419 31.8537 -21.7517 23.8731 20.1718 -1557 6 1.14062 22.1898 33.6289 -39.3586 14.574 19.5436 -1558 4 0.65227 22.798 33.0535 3.91391 -2.7929 6.08546 -1559 4 1.82717 21.8879 33.088 34.4042 -16.5957 -27.8984 -1560 6 17.4513 16.8201 9.93098 -1.82085 -23.3459 26.2514 -1561 4 17.8906 17.1746 9.18159 7.86355 15.3521 -22.135 -1562 4 18.0267 16.0779 10.2085 -7.73246 7.19916 -1.96586 -1563 6 18.7435 29.8048 14.4095 21.7061 -3.72347 40.0221 -1564 4 19.5652 29.5706 14.9087 -19.4331 3.67999 -8.42588 -1565 4 18.9661 29.6909 13.4944 1.97037 -1.23698 -19.2163 -1566 6 39.4071 6.51101 13.0179 12.0574 6.81682 -11.0022 -1567 4 39.7785 7.30288 12.5709 -10.193 -11.7897 7.6563 -1568 4 39.9532 5.78104 12.6849 -4.03584 4.98089 5.48617 -1569 6 54.0977 38.2821 14.3159 8.76467 -13.509 23.2458 -1570 4 53.5116 38.6447 15.0061 0.0542658 1.01747 -18.4972 -1571 4 53.8554 38.6311 13.4594 -12.9742 11.219 -5.93773 -1572 6 7.52036 32.013 20.9427 34.362 14.2167 21.5407 -1573 4 7.05735 31.9924 20.1252 -18.8869 -6.37038 -21.2822 -1574 4 7.04171 31.4816 21.5607 -16.1882 -11.3569 11.099 -1575 6 26.965 15.5039 13.8257 -10.8147 -22.3452 14.7237 -1576 4 27.2177 14.7358 14.3683 8.65177 6.42067 -5.59001 -1577 4 26.0429 15.6169 14.0906 -6.80859 9.66341 -6.51148 -1578 6 18.3782 16.4473 32.1249 -4.95226 -1.86998 -9.87987 -1579 4 18.1426 16.6374 31.1969 4.73263 -0.719504 8.39792 -1580 4 19.0836 17.0573 32.3614 6.73072 6.57595 -2.73442 -1581 6 52.4873 31.678 23.2415 -44.1119 -6.58328 47.4356 -1582 4 52.4708 32.2686 24.0415 7.23299 -8.75358 -21.8316 -1583 4 53.1739 31.883 22.645 31.3465 14.6123 -23.9869 -1584 6 2.16824 9.71317 28.2162 5.46837 -18.1801 7.45826 -1585 4 2.48183 10.5213 27.7929 -7.61484 8.72751 3.65687 -1586 4 1.37959 9.87032 28.768 3.44281 10.2362 -4.06622 -1587 6 32.9194 0.0905733 22.5781 10.5432 -20.5017 -7.42813 -1588 4 33.2395 41.1185 22.3208 -17.3926 6.61176 1.08087 -1589 4 33.7441 0.505918 22.8191 5.29332 16.1982 3.6992 -1590 6 20.7309 41.5697 38.6372 28.3147 -14.9122 -44.687 -1591 4 20.0328 41.0591 39.0281 -13.7779 -1.58578 11.2509 -1592 4 21.0348 40.9602 37.8857 -7.98591 29.4899 32.1121 -1593 6 43.3035 24.332 12.1458 11.7575 -1.61212 -4.71191 -1594 4 43.2118 25.2792 12.3722 8.64503 -11.1136 -9.01316 -1595 4 44.1249 24.1975 11.6011 -17.6772 13.9566 14.4164 -1596 6 22.028 36.2965 11.8178 -12.5217 11.0116 -6.64335 -1597 4 21.6755 36.9888 11.229 7.35556 -7.61462 10.605 -1598 4 22.8593 36.0261 11.4203 4.02803 -2.23458 -0.408194 -1599 6 50.7458 20.5312 30.3336 -27.3371 19.0798 0.575242 -1600 4 50.2829 20.0188 31.024 4.3389 0.549123 -5.17754 -1601 4 50.1148 21.2814 30.1453 20.3707 -20.1638 4.65154 -1602 6 20.8352 3.85006 18.1924 -4.58005 6.82859 16.651 -1603 4 21.6331 4.17131 17.7775 4.55578 1.29171 -4.07778 -1604 4 20.7516 4.34878 19.0287 -0.852135 -6.30171 -7.97465 -1605 6 4.00732 20.6422 6.98905 -51.5603 -31.2986 19.6291 -1606 4 3.1116 20.4695 6.56725 35.2765 12.481 -1.34365 -1607 4 3.83148 20.2497 7.8921 17.5771 16.9916 -21.2359 -1608 6 11.9503 15.4361 41.4392 2.8915 -19.3712 8.63656 -1609 4 11.9967 14.4718 41.7234 3.98465 29.7679 -14.4511 -1610 4 12.4631 15.5787 40.6176 -3.08486 -9.43894 7.49139 -1611 6 3.00006 18.5443 38.9307 7.29951 -23.84 25.6029 -1612 4 3.57591 17.7463 38.8471 -9.50595 12.5214 2.28144 -1613 4 2.93408 18.9335 38.0756 -3.85177 13.2219 -26.1975 -1614 6 8.60604 38.8696 11.3027 41.4164 30.2615 0.48057 -1615 4 9.41419 39.0226 10.7506 -16.8144 -5.25469 8.62565 -1616 4 8.21901 38.0768 10.9944 -17.9318 -38.1368 -15.4555 -1617 6 12.9777 33.9736 38.4849 13.2116 9.7409 3.49313 -1618 4 12.6169 33.1824 38.0476 12.8065 1.18326 0.516457 -1619 4 13.9558 34.0654 38.367 -20.6967 -9.66923 -0.235313 -1620 6 4.68265 11.9882 6.05233 -5.36104 -17.6375 -21.4001 -1621 4 3.82121 11.6194 5.80881 -7.3972 4.97776 10.103 -1622 4 5.22981 11.6659 5.30604 -0.806592 6.4598 12.5779 -1623 6 10.8388 15.9226 25.2234 -25.8257 0.885817 -3.68505 -1624 4 11.7194 16.2357 25.361 23.5714 9.8582 3.12124 -1625 4 10.3656 16.637 24.773 5.49819 -5.38784 0.449897 -1626 6 20.7519 3.25216 6.54608 14.2232 16.6176 4.63006 -1627 4 20.286 2.47445 6.25961 -10.3965 -11.4853 -2.16446 -1628 4 20.1859 4.03183 6.47283 -6.25253 -2.40724 -3.99784 -1629 6 47.6296 39.155 31.2075 -6.94169 16.2372 -29.2685 -1630 4 46.6717 39.1522 30.9686 19.778 5.05469 4.61154 -1631 4 48.0746 39.7923 30.5789 -18.3255 -25.0069 20.1215 -1632 6 8.32942 27.7692 27.6861 -22.9675 10.5768 13.2964 -1633 4 7.92083 27.0814 28.2574 8.55111 11.2092 -8.24047 -1634 4 9.05389 27.3382 27.2479 10.5137 -11.4359 -5.41666 -1635 6 33.26 40.3166 33.4176 17.9089 -0.14465 -4.13778 -1636 4 32.5337 40.9457 33.2593 10.2249 -4.59604 -5.86803 -1637 4 34.0027 40.4737 32.781 -17.2015 3.54767 8.86095 -1638 6 24.5063 34.6298 27.2698 0.491312 8.45089 -9.78892 -1639 4 24.8706 35.531 27.0561 -9.74802 -22.5685 0.190878 -1640 4 24.1 34.2837 26.4337 10.8101 11.1551 19.1745 -1641 6 13.3248 36.7606 35.7302 31.7841 1.54421 8.12469 -1642 4 14.2215 36.6075 36.119 -13.0291 10.9369 -8.07597 -1643 4 12.8242 36.0333 36.0767 -19.6956 -11.898 1.78685 -1644 6 34.0654 20.1519 33.2169 18.328 45.6356 -7.38724 -1645 4 34.7846 20.5927 32.7056 -13.2567 -20.8909 7.62801 -1646 4 33.6055 20.9496 33.5712 -4.62613 -21.3045 2.82084 -1647 6 22.8301 33.56 31.6141 4.86266 11.3389 -12.2002 -1648 4 23.5774 34.1707 31.5466 -2.83601 4.36281 -5.03091 -1649 4 23.1188 32.9172 32.2538 0.234413 -13.6868 11.6365 -1650 6 23.7437 2.42751 19.8437 5.37542 22.288 12.015 -1651 4 24.549 1.92657 19.7151 11.8542 -9.34304 -3.08207 -1652 4 23.0522 1.96699 19.3939 -17.1839 -15.7883 -12.7178 -1653 6 10.5922 1.64055 20.5239 -11.6119 -4.18685 -4.47424 -1654 4 10.0475 0.976152 20.0603 6.63037 0.339841 6.84259 -1655 4 10.5 2.45781 20.009 1.22375 1.55874 1.33627 -1656 6 6.49834 24.8637 7.80908 13.1619 -16.462 -27.2261 -1657 4 7.39752 24.8711 7.42138 -7.39511 8.18905 12.026 -1658 4 6.07255 24.1767 7.26903 -7.5733 6.7583 6.8074 -1659 6 54.7892 32.5297 25.4757 -1.36407 18.5665 -18.8778 -1660 4 54.0312 33.1434 25.3693 10.0694 -13.7478 6.1371 -1661 4 0.333918 32.6202 24.6425 -12.8409 -6.42816 22.883 -1662 6 6.2467 20.1884 28.9797 -14.5872 3.94595 -2.55046 -1663 4 5.42154 20.1642 28.4577 8.07739 1.90281 8.6477 -1664 4 6.84484 19.6236 28.4838 10.3646 -4.74821 0.341067 -1665 6 50.0565 21.6117 11.3373 -2.04109 28.5423 -29.4123 -1666 4 50.95 21.7264 10.9878 2.40449 3.31798 -5.14809 -1667 4 50.1463 20.9073 11.9368 0.900865 -33.3483 27.1981 -1668 6 43.4794 33.5181 19.6392 10.2306 -3.22473 -8.26676 -1669 4 43.7308 33.5714 20.5426 20.9097 -0.172793 18.6354 -1670 4 42.5556 33.6283 19.7345 -31.1875 3.87355 -8.92325 -1671 6 30.8203 7.18413 41.0653 -47.5647 29.7584 13.5959 -1672 4 29.9879 7.63165 40.681 33.629 -21.8567 10.9994 -1673 4 30.7637 7.50249 0.10761 7.36747 -14.0232 -31.1296 -1674 6 12.1328 25.8622 11.0863 -33.3162 -17.1307 -4.35232 -1675 4 11.2035 26.0164 10.7385 31.652 5.74526 10.6132 -1676 4 12.7063 26.6022 10.9281 7.22016 21.1466 -6.88425 -1677 6 47.8272 5.81934 17.7377 34.4122 -10.5063 -19.6374 -1678 4 48.0885 5.28838 16.9377 -7.84164 17.03 17.5567 -1679 4 48.6906 6.1712 18.0872 -20.5621 -5.0871 -4.09565 -1680 6 35.1646 12.9005 16.5891 -8.94037 2.15609 -8.82704 -1681 4 35.428 13.0005 17.5199 -6.39768 8.78744 -5.13392 -1682 4 34.5308 13.6301 16.3523 17.2323 -15.7422 12.9621 -1683 6 10.4611 10.6156 33.9687 -31.8989 -9.58391 14.7288 -1684 4 10.7981 11.3375 34.5166 5.24051 -2.75865 -7.26377 -1685 4 9.62118 10.4004 34.4306 17.5569 -1.50819 -12.473 -1686 6 9.86916 7.4616 9.67483 -1.17411 0.415312 -19.5192 -1687 4 9.17172 8.12646 9.7346 0.921409 2.8109 10.1471 -1688 4 9.97058 7.3459 8.70248 1.1017 -0.154201 19.4763 -1689 6 11.1489 9.5612 29.1408 -3.50418 -13.4139 2.93109 -1690 4 10.6848 9.26325 29.9428 4.68224 5.10434 -5.79998 -1691 4 11.3989 8.73954 28.6776 0.998479 5.88331 1.3781 -1692 6 46.4028 12.7539 37.8993 8.34964 0.221 -8.93676 -1693 4 46.6625 12.9969 36.9769 -3.46511 -1.57209 17.4302 -1694 4 46.8246 13.3669 38.5286 -1.63466 -3.53539 -5.22058 -1695 6 4.76485 19.028 16.0085 -13.5875 12.8334 -9.71245 -1696 4 4.2246 19.0797 16.8211 14.4547 -7.44532 -2.23877 -1697 4 5.5965 18.5831 16.2078 1.83868 -2.3176 10.3072 -1698 6 50.2593 39.8135 19.3633 -11.209 7.32279 -16.1387 -1699 4 50.2357 39.0929 20.0186 -9.83071 -0.813057 -10.1916 -1700 4 49.5811 39.7404 18.6324 20.3589 -6.83946 23.6454 -1701 6 3.57863 23.2976 26.309 -19.8478 3.89203 -2.42552 -1702 4 2.95325 23.1663 25.5593 11.1236 -1.69658 12.5574 -1703 4 3.09228 23.9147 26.9028 8.7219 -10.8877 -9.85517 -1704 6 43.325 18.2347 20.509 -6.81505 -1.42332 -3.46621 -1705 4 42.8171 19.0284 20.7204 1.20306 1.51529 1.23812 -1706 4 43.8577 18.0426 21.2915 2.12676 -2.58083 4.4502 -1707 6 14.5031 41.5275 19.7277 -3.40329 -5.13047 -40.8094 -1708 4 13.9246 41.7804 20.437 0.184992 5.83632 25.1113 -1709 4 15.42 41.4218 19.9774 10.3149 -1.62678 14.571 -1710 6 29.2836 29.8681 26.9083 14.7251 3.00272 -32.0725 -1711 4 29.2754 29.741 25.8744 6.18055 14.2787 56.2455 -1712 4 30.1283 30.2623 27.2985 -22.384 -15.5718 -22.4063 -1713 6 6.3217 26.153 11.5726 -10.9318 2.11689 -6.65038 -1714 4 6.21736 25.7454 12.4421 7.16784 6.77942 9.71283 -1715 4 6.96084 26.8819 11.5675 -0.124344 -5.20772 8.78036 -1716 6 27.6636 9.22988 15.2432 27.2347 15.0341 -6.49447 -1717 4 28.4103 9.83484 14.9873 -20.1055 -14.3916 8.85848 -1718 4 27.7674 8.48088 14.6445 -1.45999 -3.40178 1.02673 -1719 6 29.7804 38.0662 17.0819 -1.94795 -3.59677 -9.66723 -1720 4 29.6031 37.2203 16.6025 -2.55573 18.1678 4.54076 -1721 4 29.1155 38.7497 16.8561 3.55432 -16.3657 1.57327 -1722 6 52.2257 28.7184 4.26028 43.5541 11.735 -13.9492 -1723 4 53.1498 28.7813 3.86382 -28.9168 1.3453 15.0129 -1724 4 51.9642 27.8111 4.13511 -4.98861 -18.1961 -3.0857 -1725 6 17.1716 16.6708 6.09349 0.800403 22.8617 11.3476 -1726 4 16.9906 17.4665 6.64994 5.32834 -8.85643 -15.9231 -1727 4 16.9912 15.9587 6.69883 -0.0606397 -19.1034 5.18453 -1728 6 36.6551 7.54529 33.4256 0.520164 -21.8515 26.6937 -1729 4 35.9994 7.02185 33.9501 8.71508 10.7979 -12.9224 -1730 4 36.139 7.85703 32.6949 -12.9525 8.58568 -17.7829 -1731 6 26.1712 3.13186 9.59195 18.1066 21.2961 -28.5304 -1732 4 26.5502 3.5196 10.357 16.0028 12.4994 23.003 -1733 4 25.6506 2.45477 9.93435 -32.3265 -38.1289 14.2303 -1734 6 1.19956 17.1196 33.1708 -2.2935 18.3305 -9.07621 -1735 4 1.01553 17.8006 32.4822 1.56489 -10.8534 12.1427 -1736 4 0.844206 17.4429 34.0214 2.04572 -1.59411 -6.06332 -1737 6 29.1739 10.178 5.37516 -2.40587 -18.3881 11.7134 -1738 4 28.5386 10.354 6.08377 0.376669 4.93981 -3.98875 -1739 4 29.4881 9.26834 5.54278 -5.29161 7.67482 -7.40705 -1740 6 9.22817 21.1342 0.188585 30.2393 3.90367 9.01386 -1741 4 10.0008 20.6689 41.6954 -19.6386 2.89796 1.05729 -1742 4 8.40981 20.8027 41.7407 -2.68979 -7.66638 -7.21336 -1743 6 7.42006 26.8879 34.8536 3.14545 16.5486 30.4349 -1744 4 7.04622 27.0927 35.7464 10.1233 -6.04195 -26.4158 -1745 4 6.87255 26.19 34.5186 -13.4343 -18.5802 -10.0193 -1746 6 18.6153 10.1647 3.02259 -21.2705 37.3854 6.86975 -1747 4 17.9982 9.42011 2.89287 2.11135 15.8633 3.52195 -1748 4 18.115 11.0437 3.25865 19.508 -44.5053 -11.6159 -1749 6 13.1266 21.2208 25.207 -7.78894 4.80204 -7.88194 -1750 4 12.927 21.6586 24.3646 3.95449 -7.72121 4.87382 -1751 4 12.8054 20.3208 25.1571 -2.69895 -8.80511 -3.48609 -1752 6 4.90585 24.4116 40.531 -24.4864 -14.2944 -35.1794 -1753 4 5.64285 24.6041 41.0938 21.6142 3.21823 7.1591 -1754 4 5.22115 23.997 39.6806 -3.1008 12.4445 27.1665 -1755 6 54.7234 6.29054 9.93868 16.9838 3.76988 -11.4262 -1756 4 54.1595 6.0167 10.6465 -16.0707 -8.53288 16.3243 -1757 4 -0.00708757 7.17696 10.1972 2.88265 8.42125 0.296955 -1758 6 51.7481 16.6603 19.3703 -0.380283 5.87397 -29.4424 -1759 4 51.6376 16.2748 18.4816 -6.94363 -1.60509 11.109 -1760 4 52.3909 17.3585 19.2003 6.35466 6.30558 5.78841 -1761 6 38.6244 2.9738 13.1093 11.8256 2.30897 44.7329 -1762 4 38.5518 3.44318 13.9917 -0.399232 -9.9856 -23.4333 -1763 4 38.2423 3.54447 12.4592 -11.1085 17.5319 -17.0773 -1764 6 19.4422 35.7095 9.59568 3.40577 -0.828385 -4.73593 -1765 4 18.7414 36.105 9.07989 -9.16576 -3.00828 -7.06541 -1766 4 19.0009 35.4265 10.4088 3.97598 4.46758 -4.25365 -1767 6 46.943 37.6271 25.6985 10.3793 1.77648 -5.56802 -1768 4 47.12 37.9785 24.823 -9.34628 8.6078 -10.4475 -1769 4 47.7536 37.1497 25.8683 2.27046 -5.59472 9.98269 -1770 6 20.0359 17.269 14.7493 3.99527 -1.04076 21.685 -1771 4 19.226 17.5112 15.2169 -1.54973 1.23777 -13.9596 -1772 4 20.6203 17.0021 15.471 1.89523 -0.789097 -10.2839 -1773 6 24.7462 29.2867 3.75843 -10.1451 -8.18783 10.4774 -1774 4 24.6712 28.3277 3.51733 13.2212 23.8029 -9.5704 -1775 4 25.3186 29.8222 3.19111 0.258423 -15.3949 -10.1904 -1776 6 3.43 8.91865 6.82525 30.9316 4.78471 42.1024 -1777 4 3.12906 8.84201 7.76799 3.51474 0.65101 -30.0512 -1778 4 4.4001 9.15772 6.93718 -35.8795 -6.21414 -10.2854 -1779 6 17.4867 30.5875 19.7089 25.363 -13.1809 -11.8275 -1780 4 18.4189 30.3609 19.3993 -33.7851 8.31766 10.936 -1781 4 16.9116 29.8624 19.4038 1.038 7.7974 -2.73085 -1782 6 13.2718 16.1862 39.0546 8.76191 -18.4723 6.03369 -1783 4 13.8233 16.8904 39.4031 3.30361 7.54485 1.72389 -1784 4 12.5422 16.5765 38.5789 -11.7633 13.4881 -8.40344 -1785 6 23.832 27.9756 11.5898 -7.03122 5.38421 -2.05105 -1786 4 23.0756 27.4469 11.9259 8.81977 12.3317 -3.01362 -1787 4 23.7182 28.9056 11.8688 -5.28793 -12.9553 -0.41204 -1788 6 14.4579 24.426 21.2343 -3.66896 12.863 -1.79834 -1789 4 13.9584 25.2806 21.2855 7.33453 -15.5065 2.73981 -1790 4 14.2661 23.9117 22.0367 -3.91682 9.90798 -0.991428 -1791 6 46.6073 15.1543 22.2965 -20.8333 -3.77381 -11.8272 -1792 4 45.9584 14.6421 21.811 -6.87655 -3.95362 10.1018 -1793 4 47.2458 15.2644 21.6001 24.1162 10.8017 0.759212 -1794 6 19.1409 29.7195 11.8497 24.0494 -34.2428 10.0272 -1795 4 18.8784 30.5975 11.5793 -19.1418 4.86007 -17.3781 -1796 4 18.6106 28.9994 11.4276 0.263541 23.8948 1.0376 -1797 6 36.9127 18.8084 27.6222 -22.9356 -21.6011 26.171 -1798 4 36.4352 18.471 26.8408 6.36827 4.7914 5.64024 -1799 4 36.536 18.2194 28.3533 14.6987 24.2872 -28.1415 -1800 6 35.8684 17.5378 25.4906 20.6945 -0.513689 -30.4481 -1801 4 36.5966 17.7728 24.866 -15.8574 8.27186 11.6809 -1802 4 35.9779 16.5759 25.48 -10.902 2.42848 10.2606 -1803 6 8.03691 41.9141 31.5248 13.0394 10.4535 -6.8036 -1804 4 8.57921 41.2412 31.9888 -13.1962 14.522 -11.1095 -1805 4 8.63283 0.684743 31.1326 -8.3799 -15.4286 7.32752 -1806 6 31.7059 34.8342 17.9371 1.99631 -25.0047 -8.79133 -1807 4 32.5911 34.4609 17.7211 -13.4776 12.334 6.09844 -1808 4 31.8527 35.7258 18.2497 13.1847 15.6537 3.27409 -1809 6 22.1093 41.055 5.1451 11.5479 29.9587 -53.8497 -1810 4 22.1004 40.5969 5.93279 -2.68624 -33.8843 55.363 -1811 4 22.7885 40.6204 4.60559 -4.38419 0.844423 3.37931 -1812 6 11.6153 5.16618 29.5584 -27.6475 13.1782 12.6346 -1813 4 12.1606 4.37097 29.6057 -8.91967 -2.9702 4.15115 -1814 4 10.7377 5.1092 30.0631 35.581 -10.2726 -16.0904 -1815 6 13.0239 9.45481 21.0754 -25.8377 -26.1508 -25.9824 -1816 4 13.6778 9.97234 21.4999 31.652 16.6928 15.5055 -1817 4 13.4195 8.72209 20.5617 -0.589626 12.3395 6.44381 -1818 6 12.4227 4.1736 0.163828 29.6522 45.8695 -12.8421 -1819 4 12.6651 3.77524 1.00427 0.341759 -1.42745 2.51987 -1820 4 13.0617 4.97102 0.020112 -31.9214 -41.0145 4.8633 -1821 6 45.168 14.6284 28.1023 4.783 -10.4532 13.0266 -1822 4 45.253 14.8969 27.1759 8.39119 -6.85383 -0.732919 -1823 4 45.9575 14.0916 28.3529 -13.3622 13.2892 -14.7888 -1824 6 52.571 19.2551 0.894665 -6.12931 -19.318 2.27414 -1825 4 52.6102 19.199 41.8388 0.592413 0.00811024 1.08479 -1826 4 52.8129 20.1442 1.11528 6.55776 18.4237 2.43046 -1827 6 0.161625 18.5694 30.5785 -3.0227 0.535636 4.36465 -1828 4 0.968981 18.7291 30.0798 6.18464 -7.16445 -2.53371 -1829 4 54.7907 19.4514 30.677 -10.8229 5.89199 6.00525 -1830 6 17.6528 28.1849 1.96402 -7.28907 9.7522 11.2687 -1831 4 16.9769 28.8628 1.74785 9.23997 -9.27082 -2.31394 -1832 4 17.6006 28.1534 2.93661 3.56557 1.38454 -8.44201 -1833 6 22.5099 30.1653 5.01109 -1.02808 20.8676 -0.473944 -1834 4 23.1753 30.1014 4.30975 -2.49536 -9.56192 4.09657 -1835 4 22.058 29.3206 5.04766 -1.45363 -6.71999 -4.50103 -1836 6 11.4023 8.80853 17.6459 -26.9993 9.53928 -4.75555 -1837 4 11.8645 8.1762 18.2108 15.3222 4.18532 1.52515 -1838 4 11.9865 9.48216 17.2519 4.47877 -12.4161 10.2871 -1839 6 32.2917 3.59674 26.8117 35.3382 32.7507 -4.14644 -1840 4 31.8458 3.34967 26.0065 -10.4154 -4.5889 -14.8452 -1841 4 32.8806 4.37505 26.5671 -21.1848 -26.3524 0.379863 -1842 6 26.835 37.1568 15.6529 -0.874066 14.8773 29.2405 -1843 4 26.7488 37.4766 16.567 0.376185 8.65421 -15.6923 -1844 4 26.6891 36.2303 15.7909 -0.851881 -23.4278 -14.9094 -1845 6 22.9473 3.40289 22.286 14.7574 -3.5158 -4.23343 -1846 4 23.2792 2.98888 21.4515 -4.53852 7.92848 16.4552 -1847 4 23.7307 3.68139 22.8048 -11.9145 -5.32443 -10.4265 -1848 6 14.6269 28.2214 5.19572 6.06687 6.51489 2.87291 -1849 4 14.1454 28.1555 4.36712 -3.39073 -3.27129 -8.45242 -1850 4 14.2747 28.9991 5.64824 0.61258 -1.12864 1.62503 -1851 6 20.2538 37.2031 16.5466 -28.2562 5.81675 18.2866 -1852 4 21.1004 37.4666 16.2032 21.0823 8.59207 -3.85991 -1853 4 20.0754 37.7549 17.3418 4.82626 -5.93036 -10.2325 -1854 6 17.9544 28.5616 23.889 16.4449 -8.57642 -4.83649 -1855 4 18.808 28.1928 23.5683 -20.3084 2.86715 8.85187 -1856 4 17.2559 27.9215 23.6535 6.51898 5.694 -2.26134 -1857 6 33.646 24.2349 25.2286 -4.54069 1.10679 -14.8717 -1858 4 33.6591 23.269 25.0602 3.54988 10.512 10.2941 -1859 4 34.0237 24.3938 26.1034 0.864522 -9.38336 -2.59148 -1860 6 9.98122 17.6138 2.21344 7.43797 -27.5786 -7.49496 -1861 4 10.832 17.5317 1.73219 -10.6429 3.93943 7.97636 -1862 4 9.86311 16.7639 2.69719 0.409905 15.8492 -4.6087 -1863 6 24.3357 36.801 8.92185 2.98992 -6.60779 12.1866 -1864 4 24.0742 37.6409 8.56425 -5.30422 15.3919 -5.44039 -1865 4 24.7315 37 9.77917 -2.43549 -6.6012 -3.30269 -1866 6 14.4004 4.29557 27.7519 47.583 -3.32523 5.14754 -1867 4 15.335 4.40276 27.3948 -30.4143 -4.44284 13.8265 -1868 4 13.81 4.42145 27.0177 -13.2435 3.17509 -11.8406 -1869 6 13.214 25.4576 35.3169 -22.1271 -24.6319 4.29258 -1870 4 13.1587 25.1592 36.2444 11.1778 9.47444 -6.90086 -1871 4 12.4637 24.9943 34.8985 11.1514 12.2923 -1.08233 -1872 6 43.7301 33.1781 24.4042 -1.93578 -20.5981 16.0744 -1873 4 44.3223 32.959 25.1725 -10.0543 8.3706 -19.7015 -1874 4 44.0713 33.9344 23.9169 6.22405 5.02536 3.22562 -1875 6 6.9686 30.4099 7.14637 29.0056 7.39031 21.9321 -1876 4 6.75777 29.9621 7.98042 -5.17066 0.417247 -5.37485 -1877 4 6.23168 30.2842 6.57126 -23.4728 -6.8193 -11.7975 -1878 6 44.4308 39.4237 21.7855 -4.33275 0.914597 7.54549 -1879 4 43.8654 38.932 21.1541 10.179 9.64354 2.62582 -1880 4 45.001 40.0603 21.3196 -6.51882 -12.4268 -7.79327 -1881 6 1.18424 16.4398 24.9903 -32.4903 25.5998 2.59769 -1882 4 0.976951 16.9992 24.2076 17.4753 -17.2203 8.72915 -1883 4 0.385168 16.6115 25.5394 23.4019 -14.126 -4.16352 -1884 6 8.17355 33.8284 10.6836 -2.7688 -6.92624 14.1509 -1885 4 8.34263 33.4451 9.83813 20.7133 -1.8248 -25.0865 -1886 4 7.32622 33.4212 10.8229 -22.0824 -0.650197 20.9959 -1887 6 45.3734 15.866 40.492 8.57481 -12.1553 -4.93844 -1888 4 44.519 15.6937 40.0698 -0.240559 4.546 7.41406 -1889 4 45.2892 16.6061 41.0987 -5.95018 0.957053 0.609678 -1890 6 38.79 4.28815 15.8976 0.37918 -2.10791 -10.8791 -1891 4 39.6838 3.98516 16.099 -1.14178 2.00828 6.51653 -1892 4 38.4576 4.71748 16.7012 5.69678 -4.45181 -3.36891 -1893 6 21.0946 9.20757 23.9781 -15.5567 7.8487 -28.256 -1894 4 20.9171 8.74785 23.1381 12.0597 -4.77706 12.6228 -1895 4 20.522 9.98378 23.8483 8.03519 -2.74416 16.612 -1896 6 6.47513 36.1489 20.0112 1.62078 -0.443995 1.26518 -1897 4 5.91587 35.3892 19.7749 1.1588 6.62155 -0.72477 -1898 4 7.29927 35.7814 20.3561 -3.99682 -1.77997 -1.59627 -1899 6 17.7466 23.4563 11.2529 28.5847 -29.2717 26.027 -1900 4 17.0283 23.9723 10.9251 -27.3158 17.875 -1.49359 -1901 4 17.6201 23.2782 12.2162 -8.22502 9.28058 -23.7318 -1902 6 2.23619 39.2644 23.5388 49.8561 -28.1857 -22.6679 -1903 4 2.97831 38.9599 24.1359 -27.9038 8.524 -11.8523 -1904 4 2.61824 39.0932 22.6246 -22.7997 11.7085 33.9524 -1905 6 21.7216 10.3211 3.08421 -18.2449 14.4951 30.0936 -1906 4 21.8041 10.0076 2.215 15.0715 -18.3252 -42.7176 -1907 4 20.7597 10.3501 3.18369 2.1836 1.89441 6.77029 -1908 6 13.3346 37.6456 26.8309 31.2085 -13.7023 -2.95714 -1909 4 12.8405 36.9633 27.2803 -9.16641 -7.21061 8.74396 -1910 4 14.167 37.1703 26.5501 -23.1686 18.0804 4.61389 -1911 6 45.6739 9.85296 8.82966 10.4005 6.57186 1.33947 -1912 4 45.3411 9.70411 7.93855 -5.0879 -2.60549 -0.62074 -1913 4 45.1871 9.30295 9.44221 -8.90854 -6.98805 -1.17873 -1914 6 39.813 32.3454 29.581 6.89703 -12.1014 5.95535 -1915 4 39.6485 31.4219 29.3549 -7.08038 -1.01192 -10.7476 -1916 4 40.3223 32.2375 30.3827 0.600223 8.34958 5.32896 -1917 6 39.1399 32.1558 8.97291 22.8595 -6.45003 -40.3239 -1918 4 39.6086 32.0592 8.09926 -10.5081 2.64219 35.3633 -1919 4 38.2198 32.2158 8.71089 -7.955 1.72328 8.07951 -1920 6 29.7568 11.3071 40.3305 36.1908 -28.2332 -10.1569 -1921 4 29.0987 10.6276 40.5022 -6.8613 -0.261357 1.73371 -1922 4 30.5966 10.7518 40.2867 -25.0211 23.0598 -1.19829 -1923 6 24.8367 19.8778 29.8512 -3.76004 22.8831 22.3698 -1924 4 24.8428 19.0032 30.2276 -1.20959 -17.1847 2.11456 -1925 4 24.5914 20.4528 30.618 6.24059 -13.3215 -18.0816 -1926 6 50.0702 29.4819 2.87168 7.70946 6.50978 -10.1722 -1927 4 50.8345 29.4231 3.46787 -5.92296 0.441099 -8.02421 -1928 4 50.4135 29.3271 1.96617 -11.3825 0.248157 19.2026 -1929 6 26.3309 13.2577 37.9673 -13.8105 -3.9786 -34.6653 -1930 4 27.2227 13.0528 37.6163 -4.21147 3.58808 27.148 -1931 4 26.2568 13.475 38.8976 18.37 3.27206 13.6317 -1932 6 24.3356 13.8068 16.1475 3.59325 -0.347239 -0.208698 -1933 4 24.7367 14.1162 16.9522 4.68271 -6.41054 14.6744 -1934 4 24.1923 14.631 15.6832 -6.43367 3.48529 -13.6665 -1935 6 21.9593 25.0956 8.01078 27.9223 3.76027 7.52529 -1936 4 22.6404 25.6041 7.51239 -14.7718 -5.75747 5.32796 -1937 4 22.4795 24.6555 8.71494 -11.0917 7.59151 -10.9937 -1938 6 50.1732 25.2931 29.034 -22.8769 -27.0861 -14.4889 -1939 4 50.9231 25.1249 28.4453 9.52927 7.92169 5.9345 -1940 4 50.3853 25.9631 29.6741 16.3661 14.9722 8.20298 -1941 6 23.1854 6.82331 7.6223 5.22953 23.7057 -4.54178 -1942 4 23.9785 7.3899 7.84298 -26.8007 -12.7469 -6.01791 -1943 4 22.4118 7.42329 7.468 18.2581 -13.076 4.30509 -1944 6 6.92213 5.8571 20.8332 2.72627 6.95854 -11.5419 -1945 4 7.54915 6.58218 20.6217 -11.8273 -13.0803 1.39721 -1946 4 6.56012 5.53917 19.9848 5.57208 -2.46181 7.62025 -1947 6 25.395 39.7583 23.949 6.36773 8.3837 -46.9746 -1948 4 25.6324 38.8356 24.0083 0.522678 -6.92882 12.1803 -1949 4 25.626 39.9451 22.9935 -8.38215 2.07882 31.2615 -1950 6 10.8464 30.695 2.12273 2.92699 -11.4721 29.0623 -1951 4 9.93667 30.8598 2.41274 2.41412 3.42254 -4.79395 -1952 4 11.0072 31.0743 1.26994 -5.60296 10.8359 -22.248 -1953 6 23.0784 40.5299 40.0517 -12.8303 7.3127 -19.6888 -1954 4 23.7801 40.7079 39.3995 -2.98216 -3.06267 5.67195 -1955 4 22.2752 40.9489 39.6621 13.0026 -6.04267 8.58422 -1956 6 29.2116 28.3822 37.564 -38.7174 33.0362 -17.1388 -1957 4 28.2182 28.3913 37.3962 39.4392 -4.09178 7.25715 -1958 4 29.4217 27.5495 37.9564 8.20519 -19.4736 9.10227 -1959 6 1.867 12.1738 18.0852 -6.50713 5.08339 -35.4355 -1960 4 2.57398 11.838 18.6163 6.10024 -5.16113 22.8519 -1961 4 1.13063 12.5086 18.5994 -2.48645 -2.83143 13.3981 -1962 6 35.8305 14.0949 8.56039 26.0881 18.3061 13.156 -1963 4 35.1714 13.4739 8.88749 -16.8661 -4.96187 -13.4504 -1964 4 35.7684 14.4109 7.636 -16.9096 -16.2229 2.78164 -1965 6 9.49198 39.8165 37.5846 25.5398 -19.6342 8.10058 -1966 4 10.4488 39.5668 37.3792 -35.3087 19.1509 -1.98674 -1967 4 9.11285 40.4907 37.0027 15.1686 -3.88151 -5.41116 -1968 6 3.54864 30.3444 19.2746 19.2588 -4.84534 25.5649 -1969 4 4.39288 30.8221 19.2218 -5.35887 2.33403 -8.35831 -1970 4 3.69938 29.8 20.0823 -8.98886 6.07327 -15.723 -1971 6 36.3172 32.3761 17.5568 -52.716 -14.5505 -10.7859 -1972 4 37.1181 32.7413 17.8285 45.3049 23.5946 19.1732 -1973 4 36.5447 31.7674 16.8589 0.0557097 -8.91784 -8.34906 -1974 6 22.0674 24.5243 41.4066 13.5104 10.4808 14.5301 -1975 4 21.9193 25.2614 0.114872 1.55544 -1.48024 -5.36737 -1976 4 21.3782 24.5469 40.7428 -11.5581 2.78113 -8.36201 -1977 6 45.7659 15.6016 11.6394 9.02046 4.78635 -7.96304 -1978 4 46.6299 16.0103 11.8091 -2.50167 -1.58301 0.968075 -1979 4 45.9087 14.6499 11.5698 3.7439 -8.72722 -0.994242 -1980 6 22.3679 20.3809 16.0361 -10.6504 -17.4294 -19.3744 -1981 4 21.763 20.3139 16.7773 -4.42579 5.53693 13.3566 -1982 4 23.0073 21.0579 16.2253 11.6801 17.1208 13.2616 -1983 6 25.8325 25.7487 18.9031 6.26908 13.5994 -10.9759 -1984 4 25.2398 26.4837 18.648 3.49723 -12.6326 6.8661 -1985 4 25.3435 25.2434 19.5576 -3.6765 -3.23145 -0.768961 -1986 6 35.3178 34.202 33.2905 -17.6504 -29.1706 1.13026 -1987 4 35.3983 35.1402 33.2641 1.24044 29.706 -1.15043 -1988 4 34.4344 34.0427 33.6774 7.05439 -0.467604 -1.03347 -1989 6 39.2901 17.1075 17.3833 -11.3112 -26.2042 -1.68945 -1990 4 39.9794 17.7123 17.5836 17.425 19.0869 4.79839 -1991 4 38.575 17.6263 16.9966 -1.50153 2.1098 -0.940241 -1992 6 0.398412 14.9432 21.7856 9.03058 1.70326 -1.90296 -1993 4 54.4474 14.9193 21.5731 -3.898 -0.019948 -1.7993 -1994 4 0.528431 14.174 22.3634 -0.170355 0.861544 -0.399335 -1995 6 15.987 23.2263 17.7743 4.36624 14.6934 -7.14303 -1996 4 15.4857 22.9799 16.9684 3.82047 1.22984 7.38673 -1997 4 16.1722 24.1939 17.7179 -4.44652 -15.4901 1.96988 -1998 6 5.24865 11.1141 17.5618 6.95422 37.8037 -9.42255 -1999 4 4.73778 10.3127 17.5906 4.69561 -15.2682 10.3552 -2000 4 6.07662 11.1201 18.0866 -14.6292 -19.4463 0.240297 -2001 6 9.34435 36.7122 13.2675 14.3848 -20.4853 -8.45434 -2002 4 9.62142 35.7704 13.1913 -3.31983 12.7393 -0.467066 -2003 4 9.65952 37.1602 12.4706 -4.49166 -2.86228 3.29419 -2004 6 25.4918 33.5767 0.585194 -13.2513 47.819 -13.0434 -2005 4 25.5067 34.5261 0.924259 2.87868 -31.0124 -5.96193 -2006 4 25.9276 33.0244 1.21144 10.5779 -12.847 23.4116 -2007 6 17.3034 24.3894 31.3332 -3.83374 11.0726 -5.16798 -2008 4 17.6693 25.1812 30.9068 -1.9735 -3.85303 -0.254684 -2009 4 16.6127 24.6926 31.9382 -2.66612 -1.73239 2.61398 -2010 6 50.552 32.7161 27.7939 3.69414 -2.86079 -12.6149 -2011 4 50.6897 33.0491 28.6758 -0.144502 8.45372 13.0825 -2012 4 49.6264 32.8868 27.6344 -12.0524 -1.73095 -4.05681 -2013 6 2.253 37.2274 16.11 8.45807 0.136394 4.49883 -2014 4 3.21927 37.2459 16.107 -3.10104 -5.97474 -11.5471 -2015 4 2.06307 37.5747 16.9848 -8.61924 1.9026 3.91491 -2016 6 25.7683 33.176 8.40354 -18.9203 -11.3347 4.07551 -2017 4 24.8717 33.1921 8.8134 13.9609 -2.48357 -8.81655 -2018 4 25.7602 32.4226 7.7918 -3.67744 3.53954 1.65329 -2019 6 24.768 7.83219 25.4219 17.632 21.1734 16.2998 -2020 4 25.4945 8.36147 25.0103 -20.1597 -14.0103 5.71998 -2021 4 24.2535 7.44908 24.728 -12.2137 -5.73332 -20.4071 -2022 6 44.006 27.3325 21.546 30.1554 -7.9652 -11.3918 -2023 4 43.2457 27.8583 21.7575 -19.7371 1.57643 -2.46296 -2024 4 43.7964 26.4976 21.0884 -11.5694 12.3441 5.98804 -2025 6 20.8391 32.0716 6.72617 12.9902 -8.35788 -26.5741 -2026 4 21.6065 31.456 6.61879 -16.2643 13.1482 10.0653 -2027 4 20.6646 32.3142 7.64123 9.40483 -3.67012 8.54308 -2028 6 0.615177 26.1024 3.99379 -2.52029 5.686 8.70358 -2029 4 0.872898 25.4419 3.3518 0.34785 -8.86692 -8.8337 -2030 4 1.24928 25.9906 4.70547 -1.00806 2.16518 1.82635 -2031 6 23.6932 0.22266 22.8575 19.6208 -9.09848 8.51526 -2032 4 23.2991 1.09802 22.9795 5.26519 -2.66393 -0.960482 -2033 4 24.6108 0.216177 23.2468 -26.6208 7.90328 -9.41734 -2034 6 35.6316 26.9489 6.47476 -11.9227 4.67096 -7.07616 -2035 4 36.2784 26.7656 7.18499 -0.847143 10.2035 -9.59556 -2036 4 35.6247 27.8854 6.12936 11.6979 -23.4314 22.5499 -2037 6 50.1669 7.09081 18.6924 -7.14542 -1.6973 -3.47771 -2038 4 50.8011 7.27946 17.9805 -1.08143 -0.293524 0.841141 -2039 4 49.7425 7.94753 18.8476 4.63932 0.367722 -3.05405 -2040 6 12.4741 14.8288 12.1922 -8.10271 -9.61402 10.4649 -2041 4 11.6958 14.4794 12.6802 13.1948 7.08912 -7.97814 -2042 4 12.1183 15.3251 11.4609 -4.91784 2.70917 -6.99785 -2043 6 52.4614 22.3688 36.3388 -11.0199 -17.3524 -23.0567 -2044 4 51.6251 21.9183 36.1306 -2.17212 11.6706 13.3338 -2045 4 52.9952 21.963 35.6316 8.38603 12.1418 11.4133 -2046 6 41.778 11.4842 39.1192 -2.94788 -8.5466 -71.3066 -2047 4 42.0712 11.6935 39.9642 18.9262 14.1801 48.2999 -2048 4 42.4688 11.7778 38.472 -13.5225 -5.5757 18.7019 -2049 6 13.7869 22.5139 39.1025 -32.0544 -7.10206 -10.9841 -2050 4 12.8164 22.2898 39.2995 40.1723 6.0649 -15.4789 -2051 4 14.0276 22.2847 38.1645 -11.932 2.241 24.8997 -2052 6 28.7471 19.519 21.8427 26.201 -31.4587 -3.42241 -2053 4 29.5077 18.8642 21.7553 -27.3151 19.4313 7.21597 -2054 4 28.709 19.939 20.977 -1.33904 3.86677 -3.41873 -2055 6 8.35104 21.6464 36.3873 -9.70021 11.1463 1.78198 -2056 4 8.59231 22.5715 36.3877 5.92817 6.74417 -5.91108 -2057 4 7.6521 21.6323 37.0621 1.10663 -7.27579 -5.05072 -2058 6 39.9466 23.9759 15.2079 21.5993 -7.98015 -41.1742 -2059 4 40.8727 23.6245 15.2724 -23.8836 11.1149 -0.884493 -2060 4 39.7538 23.9548 14.2182 -0.675121 3.14563 34.0025 -2061 6 8.14826 38.6974 22.5407 10.5164 -8.10765 28.5856 -2062 4 7.68497 39.3831 22.0542 -4.5186 11.15 0.90042 -2063 4 8.43687 39.0737 23.4204 -11.1896 -2.29822 -22.518 -2064 6 10.8609 20.1732 28.9608 12.8413 -0.923384 7.34695 -2065 4 10.0131 19.7426 29.0637 -5.9523 -4.47565 4.1188 -2066 4 10.8844 20.5008 28.0696 -0.703946 5.19258 -12.1525 -2067 6 36.9008 23.822 41.8156 -12.4363 21.7846 -10.0393 -2068 4 37.5711 23.2333 0.167128 40.9996 -19.7248 12.2972 -2069 4 36.1173 23.3131 41.9445 -23.6506 -5.40851 2.0223 -2070 6 23.7894 40.6868 33.3454 12.8596 -15.6087 -7.6142 -2071 4 23.0064 40.9655 33.8068 -12.9523 11.6172 4.83708 -2072 4 23.8763 39.7481 33.6232 3.5481 12.5289 -6.50269 -2073 6 4.67002 19.3025 35.4081 28.9654 -8.37802 15.8464 -2074 4 5.50304 19.0977 35.9037 -20.926 10.8248 -6.78781 -2075 4 4.54874 18.5079 34.879 -7.50763 -2.93955 -6.02594 -2076 6 9.44906 25.7726 10.897 4.32597 -4.58851 8.60165 -2077 4 9.18995 24.8319 10.8983 -5.5655 4.98255 -0.925486 -2078 4 8.69969 26.3126 10.6078 0.159443 -6.7376 0.514864 -2079 6 27.2776 22.4912 13.6121 -0.517147 -7.99313 -8.85992 -2080 4 27.155 21.7331 14.2088 0.0551372 2.14825 -2.63665 -2081 4 27.5226 22.1158 12.7439 -1.12325 6.52643 14.1544 -2082 6 41.0473 18.7721 23.2805 -1.65607 -7.19044 -7.91226 -2083 4 40.4257 18.2083 22.8124 7.09703 -3.21037 0.549063 -2084 4 40.4899 19.4448 23.6465 -2.2525 13.4867 10.2584 -2085 6 46.4847 28.3568 20.1596 21.4343 7.62243 20.4812 -2086 4 45.6558 28.0725 20.6313 23.6124 6.3397 2.68094 -2087 4 47.3103 28.4552 20.7557 -43.4876 -6.08109 -17.1535 -2088 6 14.856 15.3945 30.0569 12.1054 -1.48105 24.8406 -2089 4 14.6669 15.4041 29.1302 -8.67008 -4.83168 -20.7775 -2090 4 14.3859 14.629 30.4429 4.17574 5.50589 -6.96103 -2091 6 23.5299 24.7674 35.2089 8.01546 19.7663 24.3744 -2092 4 22.8065 25.3632 35.4756 2.8295 -9.26237 -7.23473 -2093 4 24.1647 24.8645 35.9517 -5.58112 -4.18239 -8.07128 -2094 6 19.8979 24.2128 28.4372 -8.55524 33.371 -10.5251 -2095 4 20.118 25.106 28.0235 -7.554 -30.7898 14.4583 -2096 4 18.9386 24.2465 28.5992 8.91169 -0.342387 -2.75065 -2097 6 45.9653 7.62821 20.2375 0.645938 -6.46631 40.9505 -2098 4 46.1455 7.81465 21.2011 -4.75538 -9.14986 -26.6761 -2099 4 46.2053 8.42523 19.7798 3.02803 13.7202 -10.1214 -2100 6 38.0274 12.476 8.2804 -12.7973 12.3245 -4.6187 -2101 4 37.3544 13.1993 8.5286 18.4233 -41.2645 -20.6098 -2102 4 37.689 11.8001 7.60922 -1.16355 31.2483 23.3325 -2103 6 46.9232 18.1908 8.45127 -20.6048 6.85227 14.7641 -2104 4 46.2435 17.4987 8.55233 4.56757 4.50302 -0.225601 -2105 4 47.4224 17.9381 7.68168 11.4282 -5.99968 -17.9171 -2106 6 10.854 13.9656 9.37577 10.6617 18.3473 -18.9154 -2107 4 10.3554 14.661 8.90618 -4.87744 -10.6328 11.7585 -2108 4 11.7492 14.0754 8.99486 -7.79483 -7.36366 10.4335 -2109 6 34.413 5.42618 14.0852 -12.6861 0.159125 26.6885 -2110 4 35.1199 5.9296 13.6715 10.4361 -4.78744 -13.6438 -2111 4 34.2786 4.53955 13.7091 11.464 2.02167 -7.62295 -2112 6 0.18261 0.234369 22.9555 2.77695 -16.1069 -0.480131 -2113 4 0.268342 41.6651 22.1144 -0.0234796 4.94264 7.55149 -2114 4 54.831 1.09037 22.7433 -8.12427 18.964 -5.90735 -2115 6 40.9343 30.5497 37.8912 -0.822728 -5.40818 -2.29365 -2116 4 40.0406 30.8803 38.1728 23.6728 -16.1598 5.2797 -2117 4 41.3254 29.8415 38.4693 -14.8835 20.0143 -6.13723 -2118 6 16.6534 17.3205 12.6874 14.7099 15.3782 -9.06546 -2119 4 16.1954 16.505 12.4572 -1.18797 -4.10455 -0.493236 -2120 4 17.006 17.6533 11.8352 -5.05849 -6.69802 12.8635 -2121 6 29.6898 5.4323 24.749 -0.0153423 -4.79708 -9.00604 -2122 4 30.3311 5.93507 24.2276 2.5605 1.293 3.45927 -2123 4 29.9547 5.54756 25.6733 0.859724 2.70473 -2.20341 -2124 6 49.8976 0.279 27.2063 11.3554 -10.6099 9.68168 -2125 4 49.8114 0.578981 26.2935 2.75523 0.634109 -3.06626 -2126 4 50.8097 41.8349 27.2847 -10.6363 5.42595 -5.44518 -2127 6 31.2372 31.739 15.2138 3.99594 22.7956 -4.27207 -2128 4 31.6256 30.8953 15.4507 4.79789 -4.71254 6.82751 -2129 4 31.9624 32.4004 15.1381 -14.4355 -14.737 3.33184 -2130 6 35.7805 24.1465 16.9504 11.9916 -3.59376 -8.04525 -2131 4 35.6914 24.9231 16.3572 2.28972 -11.6943 5.94213 -2132 4 36.6882 23.763 16.8157 -19.8391 7.30154 4.46135 -2133 6 24.2601 4.62781 36.7306 -2.73038 -12.1142 -21.0154 -2134 4 24.8177 5.17448 37.2794 5.25293 5.76293 7.44764 -2135 4 24.6802 4.67277 35.8537 -9.35577 -2.69704 9.81341 -2136 6 17.5719 12.8989 3.66466 27.7221 -13.8379 -12.2911 -2137 4 17.7111 13.5231 2.92461 -8.26776 -5.83385 13.2655 -2138 4 16.7968 13.1561 4.15408 -15.8703 8.33112 4.7305 -2139 6 4.16771 14.2922 18.2601 -1.91899 -29.1082 -10.1028 -2140 4 4.22837 13.3107 18.2109 4.90834 19.7408 -0.578384 -2141 4 3.27435 14.4381 18.5824 -9.9871 6.86755 4.44487 -2142 6 19.1699 36.8381 22.3902 -4.55286 10.0742 -5.97046 -2143 4 18.832 36.3461 23.1414 -4.92402 -9.67799 11.164 -2144 4 19.5712 36.1952 21.8056 6.33502 -12.5333 -3.55186 -2145 6 15.653 11.96 13.2084 19.351 18.6963 0.185202 -2146 4 15.6609 12.833 12.7547 -2.35489 -19.4305 9.56752 -2147 4 16.5767 11.8359 13.5469 -18.24 -1.16426 -6.81767 -2148 6 24.7461 21.9204 5.38797 -27.1503 3.38708 1.08719 -2149 4 25.0422 21.7466 6.29562 -9.42613 0.489783 0.293639 -2150 4 23.7615 21.7936 5.33342 31.5349 -1.60743 10.1723 -2151 6 52.731 18.5617 35.2291 -23.3227 -9.96089 -3.35821 -2152 4 52.3432 18.0885 34.4925 12.0283 -8.22578 -16.7439 -2153 4 51.9379 18.6142 35.7503 -4.18579 12.1235 24.3517 -2154 6 3.56339 27.2782 25.2861 -13.9068 -17.971 -11.9546 -2155 4 3.93933 27.1708 26.1554 6.48024 -2.07304 15.4908 -2156 4 3.97283 28.0403 24.8958 8.97188 17.1762 -5.24442 -2157 6 34.4703 32.9949 30.674 6.71734 26.132 41.1649 -2158 4 33.5303 32.9277 30.8218 -10.267 -13.4259 -20.1884 -2159 4 34.6757 33.5653 31.4552 13.6938 -14.1125 -21.2315 -2160 6 35.2703 23.7477 9.841 1.59588 4.98779 0.126485 -2161 4 34.557 23.9691 9.22977 0.987563 3.83206 0.754652 -2162 4 35.6213 22.923 9.5082 6.82753 -10.3388 -1.5208 -2163 6 42.4139 15.7114 8.97964 24.1102 0.334397 4.42901 -2164 4 41.6569 15.4185 8.4899 -23.1764 -3.9339 -8.15459 -2165 4 42.1019 15.9745 9.85446 -9.30455 -0.897043 1.06511 -2166 6 7.76859 28.8573 32.9442 -15.9037 16.0354 -10.4898 -2167 4 7.97908 28.1549 33.5519 6.36032 -10.9608 11.0673 -2168 4 8.54203 29.0732 32.4131 7.8922 -1.0693 -1.41065 -2169 6 17.6887 41.2397 36.4833 -13.2152 -10.2381 33.1554 -2170 4 16.9194 41.8027 36.6113 -2.7651 1.17246 3.809 -2171 4 17.9462 41.408 35.602 16.1966 5.46369 -29.7656 -2172 6 28.4973 24.2486 15.5471 -12.6583 -10.112 -30.4241 -2173 4 29.1017 24.9078 15.1992 6.65529 6.29726 4.69488 -2174 4 28.2904 23.7156 14.7389 1.39534 3.17619 21.4563 -2175 6 20.9519 16.2974 1.15248 44.1264 9.982 -6.69009 -2176 4 20.9895 15.4004 1.43432 -0.0798072 -22.9414 11.198 -2177 4 20.0538 16.5254 1.09156 -44.6028 7.62895 -2.50253 -2178 6 31.1717 40.7384 5.29995 -1.14335 -24.9234 -14.6262 -2179 4 30.3101 40.4535 4.98914 0.542473 -7.39845 -0.335603 -2180 4 31.0069 41.6267 5.54556 -2.10438 36.1837 12.2935 -2181 6 29.9172 24.7601 36.4536 2.52587 12.7881 -5.39704 -2182 4 30.4095 25.4459 35.9567 -7.35112 -4.48214 8.13095 -2183 4 30.0744 23.9625 35.9621 2.47343 -16.947 -5.4104 -2184 6 8.66853 31.0461 3.90506 3.77884 -22.5587 -9.29968 -2185 4 7.73756 30.8263 3.92016 -7.28297 1.54323 -1.95967 -2186 4 8.75192 31.9258 4.24445 1.80419 26.3875 10.0131 -2187 6 5.53845 32.6958 11.4143 8.71933 -16.8124 -2.49586 -2188 4 4.77303 33.2403 11.6664 3.11219 -11.1916 -2.75881 -2189 4 5.22904 31.759 11.32 0.456358 25.4252 4.80969 -2190 6 45.6505 35.4572 20.4414 3.44959 -7.44503 -2.03407 -2191 4 45.0984 35.4295 19.6379 6.4013 -0.712815 7.57821 -2192 4 46.1919 34.6303 20.4513 -12.6908 13.7486 -3.45541 -2193 6 19.5117 2.78375 9.7759 -32.3978 -9.59039 -17.0694 -2194 4 19.2358 3.70482 9.71872 -0.134373 3.8207 4.89971 -2195 4 18.7417 2.29322 9.36028 25.7327 11.9734 13.3495 -2196 6 54.9587 9.07031 10.9149 6.82732 -5.63024 12.2566 -2197 4 54.8294 8.9199 11.8667 -4.4018 -2.06217 -5.32285 -2198 4 0.663346 9.73371 10.8556 1.49355 -0.124783 -2.42855 -2199 6 21.0387 26.5729 14.7801 20.1883 -1.49652 -44.4677 -2200 4 21.3075 26.2685 13.8316 -13.9911 15.8829 47.28 -2201 4 20.1009 26.3915 14.9175 1.72514 -4.1332 -5.78598 -2202 6 14.1556 30.5195 27.5512 33.9559 3.86758 5.7066 -2203 4 14.6157 30.1887 28.3748 -9.20473 8.28645 -28.3289 -2204 4 14.8625 30.9321 26.9648 -24.7422 -11.1229 20.6028 -2205 6 29.8153 17.3336 31.0863 -17.242 12.2647 2.89366 -2206 4 30.6608 17.508 30.6961 22.1461 -2.37775 -6.86255 -2207 4 29.3509 18.1813 30.9961 -0.156979 -6.11616 8.89085 -2208 6 50.8803 17.2897 27.8178 -36.3925 19.5692 4.68662 -2209 4 49.966 17.6961 27.8739 30.6942 -17.822 -8.40051 -2210 4 51.3989 17.8346 28.4178 4.99425 -5.86793 -0.268148 -2211 6 46.2649 37.0836 13.9834 -5.2064 -3.89214 -29.9265 -2212 4 46.1297 37.5324 14.8008 -1.4234 12.1478 29.9589 -2213 4 45.6025 37.4999 13.3985 5.55615 -7.46483 0.310394 -2214 6 38.1938 37.2652 33.1426 -7.30823 -21.5307 12.8964 -2215 4 38.5245 37.3061 34.0621 0.43181 3.22683 -10.2889 -2216 4 38.5338 38.0078 32.6437 8.99657 15.0472 -1.17828 -2217 6 41.835 13.3432 31.1173 -10.6585 13.9874 21.8211 -2218 4 41.5818 13.8647 31.919 4.55225 -14.0949 -20.2689 -2219 4 42.3932 12.6177 31.4161 6.34511 -7.13184 -1.29627 -2220 6 46.8964 12.6581 17.833 -7.85032 10.4907 -16.4819 -2221 4 46.6484 13.6178 17.7542 4.08188 -24.8978 -7.40371 -2222 4 46.6377 12.1709 16.9987 5.46876 16.7046 19.0746 -2223 6 32.0579 10.0934 10.6503 -8.64381 28.9058 -4.43215 -2224 4 31.7849 9.65569 11.4853 0.173068 15.3159 -11.0765 -2225 4 31.7767 11.0763 10.6467 12.4785 -48.8318 10.7993 -2226 6 34.0094 11.373 6.75969 12.8388 24.8548 11.4886 -2227 4 33.4875 10.5861 6.69386 -15.1181 -21.0438 1.83339 -2228 4 33.7853 11.7772 7.62543 1.85262 -6.17932 -11.7084 -2229 6 45.3294 30.8612 19.494 8.3992 -12.4908 2.66791 -2230 4 45.3133 30.6326 20.4263 -2.2594 2.91399 10.7741 -2231 4 45.8271 30.1094 19.1443 -2.81922 5.63857 -5.34771 -2232 6 20.3557 0.57205 7.14927 -0.865045 4.87397 8.36509 -2233 4 20.1887 0.590785 8.10086 -2.30268 5.48708 -2.96522 -2234 4 20.2885 41.5556 6.94299 -1.24307 -13.5357 -7.1472 -2235 6 15.9783 39.4524 4.13892 -0.0151964 -9.48015 -5.29824 -2236 4 15.6158 39.9898 3.41173 1.6648 1.85694 12.5404 -2237 4 15.64 39.7774 4.99485 -4.20756 5.15612 -10.0141 -2238 6 52.4256 16.4667 25.1127 -17.0507 13.8269 -2.02364 -2239 4 51.8848 16.9346 25.7614 0.982734 -7.60925 5.82434 -2240 4 52.3383 17.0704 24.353 8.48557 -12.5426 -0.219872 -2241 6 38.5361 13.0039 3.23845 15.1533 54.069 38.768 -2242 4 38.651 13.64 4.04305 -2.16968 -28.4467 -44.0011 -2243 4 38.0019 12.309 3.58724 -16.6469 -22.8542 0.297491 -2244 6 35.13 29.6899 31.1766 -32.8294 1.63854 50.8714 -2245 4 35.4825 30.1651 30.4465 16.0479 15.276 -26.3528 -2246 4 34.6741 30.3613 31.7643 12.1102 -21.125 -19.7306 -2247 6 9.51973 33.7498 4.86217 -21.8826 5.77433 4.68556 -2248 4 9.27059 34.3826 5.57285 8.50621 -13.5655 -12.6408 -2249 4 10.3866 33.3952 5.041 8.90701 -1.44023 3.12186 -2250 6 21.534 22.0642 20.5279 -11.3341 -5.53839 17.2976 -2251 4 20.8989 22.7675 20.339 3.51908 1.76985 -0.685914 -2252 4 21.3133 21.7346 21.437 6.74336 6.48682 -22.5749 -2253 6 37.579 11.1901 41.2936 -40.5688 -13.8213 19.6839 -2254 4 37.9154 11.8125 40.6731 20.8822 18.4609 -22.3708 -2255 4 38.2848 10.6639 41.6667 19.2795 -3.39896 1.21846 -2256 6 33.8862 1.42431 38.7362 -9.76991 -12.243 -0.11253 -2257 4 33.6023 0.553369 38.4181 2.20193 5.31751 1.25532 -2258 4 33.9041 1.3558 39.7008 -0.574955 5.51976 -3.65617 -2259 6 4.57166 26.6812 27.9899 28.8485 -45.5436 -4.48952 -2260 4 5.15229 25.8908 28.1565 -23.3183 20.9594 -13.553 -2261 4 4.90489 27.293 28.6243 -0.866291 24.6335 11.5543 -2262 6 10.2514 0.902381 11.6154 -4.58149 -17.6537 26.8062 -2263 4 10.6592 1.12475 12.4668 -4.26503 -7.612 -8.38981 -2264 4 10.5004 1.60734 11.0484 5.83944 23.9466 -26.0443 -2265 6 17.6545 19.8255 2.35686 18.7122 -0.118329 6.29025 -2266 4 17.9031 20.43 1.64019 0.754008 -4.0492 2.7955 -2267 4 18.4832 19.3436 2.60738 -15.0404 10.1651 -4.64219 -2268 6 32.418 25.6758 16.4635 3.6076 24.4214 11.9097 -2269 4 33.0171 26.0095 17.1449 -9.06157 4.09224 -4.99535 -2270 4 32.7904 24.838 16.2462 -1.14602 -28.0291 -11.1265 -2271 6 33.2468 10.6359 0.32388 9.93322 -26.76 -6.12289 -2272 4 32.8861 10.0042 41.5485 10.341 19.2926 16.9559 -2273 4 34.0854 10.2367 0.697563 -23.7256 11.8288 -10.1734 -2274 6 4.94758 4.52061 10.1416 10.7499 4.98188 17.9077 -2275 4 4.04768 4.863 10.1726 -0.273394 -4.88493 2.42241 -2276 4 5.29522 4.53942 11.0694 -10.4701 1.63881 -23.2648 -2277 6 27.0943 16.9779 9.5563 -20.4641 3.47693 -11.2288 -2278 4 27.2045 17.5151 10.3493 -1.38601 2.5137 2.70549 -2279 4 26.2214 17.2494 9.17658 21.4447 -4.2653 12.7286 -2280 6 9.99194 10.5198 19.3763 9.42123 -1.05348 44.8422 -2281 4 10.4342 9.89794 18.8118 9.85784 -12.5922 -17.5865 -2282 4 10.1605 10.162 20.3013 -9.67835 15.4527 -31.558 -2283 6 19.5738 8.53792 27.8563 25.8928 -1.13542 15.4327 -2284 4 20.113 8.77024 28.6584 -12.6361 -5.62488 -23.922 -2285 4 20.1113 7.87775 27.3567 -13.5748 14.3815 9.08869 -2286 6 47.0629 38.9588 23.1271 -13.9792 1.44752 0.432651 -2287 4 47.6691 38.8737 22.3925 4.22694 -4.47738 -4.61135 -2288 4 46.1776 38.8683 22.7344 3.33277 3.24373 3.79368 -2289 6 19.6833 25.3678 11.2608 -44.4501 -0.725843 0.650565 -2290 4 19.0139 24.6272 11.3182 24.6346 19.551 -2.60477 -2291 4 19.1544 26.1629 11.5326 10.4738 -19.1562 -5.87093 -2292 6 27.3884 13.4531 15.7313 17.4935 -10.3398 7.87305 -2293 4 26.7289 13.8255 16.2909 -22.225 11.7393 10.4827 -2294 4 28.1076 13.2654 16.3619 5.43008 -3.78237 -14.8549 -2295 6 18.6476 14.1287 1.42435 5.12245 -4.46092 -43.403 -2296 4 18.3969 15.043 1.25229 -6.07889 7.26273 6.76186 -2297 4 19.169 13.9274 0.593091 -12.995 -1.5013 29.2583 -2298 6 42.2956 22.0175 32.4812 -31.5033 5.69606 -11.9689 -2299 4 42.0953 21.6028 33.3343 -5.26012 -0.0861087 1.91793 -2300 4 41.4492 22.4721 32.2087 27.3869 -15.7461 8.96812 -2301 6 10.0338 9.4525 2.5044 21.0744 -25.1182 9.26795 -2302 4 9.23419 9.82009 2.8603 -22.4046 15.9317 4.21557 -2303 4 10.2146 8.68383 3.09556 -0.513225 11.8796 -14.6695 -2304 6 6.81454 1.43994 21.9965 -17.8896 2.42247 -7.4431 -2305 4 5.91626 1.63042 21.618 24.8197 -16.2049 7.25345 -2306 4 7.09146 0.513113 21.8391 -15.5061 11.1514 -4.64506 -2307 6 11.279 27.0428 18.9739 -2.94846 37.5248 -0.887691 -2308 4 11.8405 27.0241 19.773 -2.49358 0.901506 -7.48985 -2309 4 11.2189 28.0198 18.7087 3.35633 -32.7966 13.2637 -2310 6 41.4624 20.5117 27.2131 -8.71247 23.609 -19.3396 -2311 4 41.6397 21.203 27.8749 -2.09795 -12.5822 -0.139714 -2312 4 41.4581 19.6661 27.6488 3.25287 -9.08293 14.2442 -2313 6 15.4472 24.107 33.4286 7.47915 5.78269 -2.8589 -2314 4 14.6947 24.3175 34.0087 6.10264 -6.26217 -2.67023 -2315 4 15.704 23.1687 33.5026 -8.54671 4.87938 10.939 -2316 6 36.1332 16.3778 10.0175 -2.81296 8.13669 8.31829 -2317 4 36.0433 15.4982 9.63146 0.0153009 -3.05325 1.23302 -2318 4 36.1908 16.2895 10.9807 1.05799 -3.5475 -8.17119 -2319 6 51.7056 16.2618 2.12066 8.195 -18.8618 -27.7488 -2320 4 51.3212 16.7491 2.82948 -13.5116 6.32013 30.1636 -2321 4 51.8333 15.3227 2.36395 -2.62212 15.8907 6.5854 -2322 6 23.4154 8.54771 39.774 19.4785 -4.07885 -14.0827 -2323 4 23.6619 8.92799 38.8876 -4.40964 -10.2511 30.1282 -2324 4 24.1933 8.06554 40.1323 -10.8686 15.1901 -10.9325 -2325 6 36.7652 34.4407 21.0996 -10.7203 -4.0633 -8.35763 -2326 4 37.1575 34.5988 20.2292 -2.24352 0.118594 1.89686 -2327 4 35.7922 34.4168 20.9564 13.0606 -0.027129 3.88767 -2328 6 14.1394 8.88964 27.2822 8.4001 33.0473 -16.3093 -2329 4 13.5583 8.17177 27.4325 -25.1847 -27.8879 6.89622 -2330 4 14.9981 8.62308 27.6007 12.278 -0.771553 4.38 -2331 6 20.6523 37.4857 25.1916 -4.76336 -9.80096 2.89409 -2332 4 20.8435 36.6327 24.7231 -2.60537 24.8018 1.29013 -2333 4 20.5883 38.2205 24.557 2.95927 -14.0914 0.587832 -2334 6 28.8259 24.466 30.0361 -12.0182 1.20484 18.6414 -2335 4 28.1863 24.5363 29.306 15.5663 0.0495978 -2.57679 -2336 4 29.6571 24.0617 29.7579 -0.701354 -5.27936 -13.535 -2337 6 8.3767 11.9994 23.6977 15.286 -11.9681 20.7139 -2338 4 9.3753 12.0245 23.8359 -31.6027 -4.22616 -3.50543 -2339 4 7.96209 11.4264 24.4013 16.8905 14.3689 -13.5243 -2340 6 16.0974 26.6628 22.9497 0.767107 4.93659 2.67852 -2341 4 16.422 25.9025 22.452 -4.69466 0.466105 1.02544 -2342 4 15.3072 26.4353 23.4595 5.90508 -1.9072 -2.1838 -2343 6 22.3492 41.3933 9.48833 17.1541 -15.2597 3.14364 -2344 4 22.6076 0.330473 9.13574 5.89797 15.5422 -4.87712 -2345 4 21.4389 41.4869 9.73785 -21.2641 2.73615 1.78898 -2346 6 49.3865 19.1849 32.379 28.5034 -27.5288 -8.8444 -2347 4 49.9591 18.5119 32.8294 -20.0237 22.3317 -7.01358 -2348 4 48.8882 19.6696 33.032 -5.7885 3.32597 15.4548 -2349 6 29.6797 28.4194 31.2347 -18.17 -6.54897 12.3532 -2350 4 30.6054 28.3362 30.9452 0.112823 -13.8933 8.50124 -2351 4 29.3632 27.6339 31.7874 27.6893 19.0339 -22.4607 -2352 6 5.1089 39.1304 23.5821 16.3589 -26.7425 38.52 -2353 4 5.38369 38.72 24.4786 -14.1195 25.2427 -41.8592 -2354 4 5.12138 40.0884 23.679 1.29424 5.88982 9.05127 -2355 6 42.9406 13.5828 41.5963 2.4548 -20.3274 5.45752 -2356 4 42.752 14.3543 41.1051 4.71299 30.6973 -25.311 -2357 4 42.1302 13.4831 0.159852 -12.9765 -12.2431 17.3873 -2358 6 21.226 12.4267 7.36435 31.2446 -3.521 -2.03074 -2359 4 20.2961 12.4647 7.18572 -19.4619 -2.59914 -12.879 -2360 4 21.5838 11.6146 6.96487 -5.92297 6.31526 1.33966 -2361 6 43.1402 26.8798 37.6925 36.8226 -18.0871 25.2922 -2362 4 42.3701 26.4861 37.2457 1.92095 -10.9538 3.42147 -2363 4 43.8051 26.2366 38.1772 -44.9135 25.1765 -29.4158 -2364 6 19.5374 10.6589 41.6895 -5.57828 -38.0023 -10.1688 -2365 4 19.1336 10.6448 0.637369 -6.5477 2.89313 17.0607 -2366 4 19.8005 11.5407 41.5226 10.6711 39.664 -4.3781 -2367 6 53.6211 10.0725 3.2523 6.57913 5.47914 -9.18923 -2368 4 54.2317 10.83 3.34927 -4.54537 -9.93589 0.0420736 -2369 4 54.0384 9.44833 2.62164 -2.29754 8.8252 9.03809 -2370 6 17.5636 20.1992 28.4305 -16.5699 17.1528 15.5915 -2371 4 18.0548 19.7019 27.7957 9.40873 -10.9714 -15.8242 -2372 4 18.1497 20.2955 29.1876 1.50874 1.07066 2.83373 -2373 6 36.8673 7.33814 1.69171 -42.7001 9.70605 -8.47937 -2374 4 37.6788 7.60022 2.09727 18.2611 10.2246 9.26811 -2375 4 36.4242 8.16776 1.39628 11.5951 -12.345 5.16871 -2376 6 29.225 41.4226 1.83075 -19.1389 21.107 -1.05665 -2377 4 28.4254 0.0289368 2.09685 16.3458 -11.1471 3.47601 -2378 4 29.1672 41.4088 0.871311 7.531 -2.47214 -5.14574 -2379 6 13.5148 3.09025 8.11784 -10.8355 13.5741 -3.86075 -2380 4 12.8447 3.80664 8.08285 8.27234 -10.6709 -2.48032 -2381 4 13.8247 3.09872 9.02804 1.30446 -5.60755 1.07776 -2382 6 15.035 29.5824 18.5052 -13.3664 3.09019 -9.07378 -2383 4 14.628 28.8743 17.9722 6.78876 3.62049 6.93265 -2384 4 14.2975 30.1967 18.6986 12.8362 -2.82157 -1.1162 -2385 6 10.5118 24.7077 24.3903 18.3301 23.9761 -31.3173 -2386 4 10.707 24.7057 23.4146 -4.2845 7.89501 28.372 -2387 4 10.0612 23.8909 24.4849 -17.9274 -27.8 13.6507 -2388 6 2.3293 13.8562 25.1542 8.14415 -2.44132 2.05706 -2389 4 1.63302 13.4321 24.6436 -3.32338 -7.08116 -5.4939 -2390 4 2.0923 14.7815 25.112 -7.52471 9.11743 -0.122921 -2391 6 31.8571 32.759 29.7983 3.65167 10.3578 -8.56752 -2392 4 30.9277 32.9381 29.9784 -0.622435 -3.80813 0.732423 -2393 4 31.8884 31.8723 29.4276 -3.71181 -5.10697 -2.58235 -2394 6 37.531 40.8209 33.967 -23.153 -16.1875 5.3836 -2395 4 37.3251 40.1347 34.6985 0.870468 26.6491 -35.3147 -2396 4 36.773 40.8784 33.3102 18.3716 -9.25033 25.8989 -2397 6 24.0485 38.1313 34.3431 -11.5105 1.837 -35.773 -2398 4 24.1907 38.198 35.2802 9.24451 -7.73664 19.5979 -2399 4 24.4675 37.3552 33.934 1.62169 3.10325 14.1331 -2400 6 37.1852 22.5711 7.36841 5.54302 -17.8805 15.7599 -2401 4 37.6193 21.7136 7.5635 -9.24307 15.2983 -3.07678 -2402 4 37.2973 22.7156 6.43503 3.10694 -1.55352 -15.3513 -2403 6 4.30637 23.241 35.6005 -21.8515 -3.12039 0.833232 -2404 4 4.28153 22.3978 35.1252 -1.17938 4.50836 1.52069 -2405 4 3.36633 23.5034 35.7569 13.5984 -2.36814 -1.35472 -2406 6 15.7372 14.8984 2.68389 5.83394 8.18523 30.6602 -2407 4 16.0581 15.8209 2.80401 -5.66096 -17.7803 -6.78984 -2408 4 15.4195 14.7671 1.79524 0.865375 8.28049 -11.4308 -2409 6 48.1667 23.1873 2.04358 2.14857 -5.2771 -14.5053 -2410 4 48.6748 23.4267 2.82287 11.4848 0.866046 3.26637 -2411 4 48.7964 22.9219 1.32588 -13.3162 5.875 14.6145 -2412 6 24.1221 19.9752 21.5371 -32.3717 23.6383 6.86593 -2413 4 24.143 19.3917 22.3107 11.6246 -2.80692 -10.3828 -2414 4 24.7866 19.7762 20.8968 22.5091 -14.1667 -7.68302 -2415 6 10.5822 29.3968 5.14403 -6.21678 -11.6361 15.7318 -2416 4 9.83188 29.7897 4.67624 10.1791 9.93667 -6.35089 -2417 4 11.4324 29.7717 4.90568 -2.60747 8.99296 -10.7541 -2418 6 5.96985 27.6957 31.2251 14.0826 -21.4471 -14.909 -2419 4 6.62108 27.1001 30.7651 -15.2176 13.0885 7.83628 -2420 4 6.49554 28.1541 31.8886 3.5811 4.10899 4.91189 -2421 6 18.524 25.7945 15.3346 -6.80319 -1.26411 -41.3947 -2422 4 18.3129 25.8537 16.2191 -1.03447 -6.47723 71.4836 -2423 4 17.8509 26.3975 15.0287 -5.96066 9.61194 -22.438 -2424 6 52.0911 37.2147 11.1191 10.7944 -12.7592 -3.2574 -2425 4 52.6735 36.5031 10.7991 -6.06835 6.24709 5.19982 -2426 4 52.6754 37.9802 11.2539 -6.64808 -1.57102 -0.449092 -2427 6 46.8545 14.6154 7.32174 -10.4102 9.08531 6.17155 -2428 4 46.1761 15.2305 7.76384 29.9054 -34.6086 -7.32766 -2429 4 47.196 13.9114 7.91569 -13.0839 18.0399 0.731203 -2430 6 22.2426 0.701706 41.6733 41.1626 12.534 -29.9538 -2431 4 22.236 1.66756 41.6378 -9.79705 -6.68715 4.90956 -2432 4 23.0808 0.492341 41.1545 -29.2322 -0.545859 23.5967 -2433 6 4.06645 14.7285 9.26505 -5.79968 22.7562 -12.5209 -2434 4 3.53709 15.5501 9.07402 9.13976 -21.8289 3.48331 -2435 4 4.94549 14.9564 8.94351 2.1847 -1.50717 0.750146 -2436 6 37.293 12.6643 37.0348 -15.3153 -6.18171 16.0178 -2437 4 37.7524 12.8164 37.9019 -17.8573 -2.14895 -9.99561 -2438 4 36.3666 12.3049 37.1727 33.7628 8.85249 1.83374 -2439 6 26.6624 29.0693 40.5955 -26.637 27.4899 13.7151 -2440 4 27.0962 28.2693 40.8235 19.1059 -29.7051 -2.9078 -2441 4 26.7436 29.2635 39.6647 9.93266 -1.33043 -11.4317 -2442 6 7.23743 13.8563 3.32048 -33.1041 -30.3754 -14.41 -2443 4 7.96064 14.4301 3.56742 25.5688 -7.52041 0.820923 -2444 4 7.42976 12.8854 3.09984 6.81051 43.2082 15.4509 -2445 6 8.94797 34.8532 28.8254 23.4184 -23.2786 -12.4265 -2446 4 9.89546 35.0323 28.6727 -12.7097 -5.00209 3.03018 -2447 4 8.59604 35.6886 29.0779 -14.3686 23.8739 12.2374 -2448 6 37.2014 40.0808 40.1141 12.7521 0.43192 13.6168 -2449 4 36.2619 40.0837 39.9632 -10.4254 2.72875 -6.67898 -2450 4 37.248 39.4512 40.8496 7.71934 0.19736 -2.65382 -2451 6 30.3728 6.17428 27.2502 2.34222 12.9127 24.6773 -2452 4 30.0491 5.75377 28.1093 17.5599 21.8776 -23.7977 -2453 4 31.0277 6.90628 27.4549 -18.5498 -22.5685 3.02853 -2454 6 10.4851 22.8816 18.2947 -6.39025 -14.7202 -25.3901 -2455 4 11.3539 23.0451 18.66 8.78619 -1.44678 0.615593 -2456 4 10.601 22.3432 17.4702 -0.435219 15.7289 22.4338 -2457 6 35.9047 14.2516 40.1476 -11.9566 8.08227 -8.12446 -2458 4 35.3828 14.5983 39.4171 17.9635 11.5828 -3.36223 -2459 4 35.2535 13.6726 40.504 -8.36759 -16.975 21.7169 -2460 6 6.70775 1.0715 17.7189 7.50642 -21.2746 -7.36561 -2461 4 6.22784 1.34485 18.5084 1.44497 -10.5234 3.95628 -2462 4 6.91772 0.0894674 17.7256 -13.4419 30.1572 13.7277 -2463 6 41.3365 34.0623 33.1636 23.1157 -5.84267 13.8333 -2464 4 40.4227 34.234 32.9444 -15.3258 11.3352 -14.6542 -2465 4 41.9184 34.5849 32.5841 -12.4833 3.91505 -3.84565 -2466 6 37.2858 0.99342 41.2878 7.36827 13.3221 -16.8172 -2467 4 37.4859 0.112276 40.9658 -1.88555 -12.2628 0.361589 -2468 4 37.4834 1.0172 0.312287 5.29267 -3.40266 15.6364 -2469 6 25.2541 30.9749 6.2071 -22.7336 2.5299 17.3506 -2470 4 26.0217 31.2424 5.69829 1.89843 -3.96463 -15.2281 -2471 4 24.4182 30.8551 5.69564 23.045 5.74277 3.20871 -2472 6 14.1871 24.4929 28.313 -6.35756 40.4048 -1.58139 -2473 4 14.3311 23.6816 28.7714 -3.10946 -31.1704 -0.0360927 -2474 4 13.792 24.4319 27.4273 2.40698 -14.1025 6.50138 -2475 6 34.2078 26.2332 36.0169 -41.3887 31.6455 20.302 -2476 4 35.1375 26.2713 36.1926 18.3831 1.21525 6.50399 -2477 4 33.7458 26.9646 36.5669 26.0782 -29.6148 -21.0343 -2478 6 32.3696 8.32545 27.9988 -31.7689 14.924 14.5852 -2479 4 32.5206 9.30939 28.0669 10.5891 -30.1429 -9.37737 -2480 4 33.1235 7.86931 27.6333 20.3768 10.5357 -6.59273 -2481 6 11.7881 0.276326 26.9686 -1.26514 -24.1343 -2.09554 -2482 4 11.7898 41.2288 26.6922 -1.19404 21.3361 9.01519 -2483 4 11.5977 0.31005 27.9205 2.09711 -1.6438 -10.9729 -2484 6 1.68282 0.256654 10.3371 7.78574 -7.1909 -12.7427 -2485 4 1.59984 41.2742 10.69 -0.913761 -2.35777 -0.20094 -2486 4 1.41183 0.821253 11.0453 -5.61238 10.3042 16.839 -2487 6 6.75659 13.8554 8.24275 2.15336 8.75665 -12.4729 -2488 4 6.4538 13.9004 7.29654 11.603 6.79512 25.9161 -2489 4 7.29723 14.6482 8.44053 -3.39366 -6.31817 -8.96948 -2490 6 22.229 20.5516 6.16712 -19.4021 -6.23502 11.2792 -2491 4 21.7175 21.3783 6.29668 6.22315 -10.0472 -0.391558 -2492 4 21.7004 19.8262 6.58709 9.33903 15.1246 -7.94106 -2493 6 17.3809 20.4508 10.8712 -6.33142 3.08518 -4.04876 -2494 4 16.5461 20.08 10.4568 21.8919 23.129 5.85777 -2495 4 17.5363 21.4129 10.6625 -13.97 -26.3983 1.7074 -2496 6 17.7006 4.52466 19.5892 5.66371 -4.97651 -9.86024 -2497 4 16.9376 4.52739 20.1892 -4.06273 -5.34645 -7.80596 -2498 4 17.5412 3.84457 18.8839 -0.885651 16.9891 23.3258 -2499 6 0.475545 18.1168 40.0844 5.30586 -7.45209 -16.0452 -2500 4 0.255658 18.7395 40.7612 -0.602959 14.3131 10.4938 -2501 4 1.33302 18.3868 39.7002 -7.70736 -6.31105 3.74686 -2502 6 22.9439 24.8338 27.8349 -3.23408 23.09 -51.7359 -2503 4 22.7283 25.5292 27.1178 5.97449 -27.0764 31.3639 -2504 4 22.8278 25.2464 28.677 -4.11703 14.8593 21.0934 -2505 6 42.7959 39.1553 26.7627 -13.6288 14.9904 24.3142 -2506 4 42.9559 38.4383 26.1586 10.7263 -7.78522 -15.113 -2507 4 43.351 39.9224 26.5692 3.77188 -7.24305 -5.18193 -2508 6 26.2354 3.05796 21.7982 1.74018 25.1467 -10.7915 -2509 4 25.6923 3.78105 22.1642 10.9011 -13.8467 -3.1836 -2510 4 26.7888 3.50003 21.1142 -10.0122 -11.5362 10.4851 -2511 6 54.6007 9.88011 29.5829 2.61324 -0.835643 16.9334 -2512 4 53.983 9.1383 29.6239 1.49377 0.577448 -2.59463 -2513 4 54.746 10.0983 30.5296 -2.21833 -1.79811 -18.9561 -2514 6 24.7578 33.7363 20.5387 -17.5006 5.04967 -0.0763559 -2515 4 24.6934 34.6555 20.8512 7.60819 -4.12262 3.6003 -2516 4 23.9235 33.6132 20.0554 5.3121 -3.42637 -1.44671 -2517 6 41.6963 16.3109 0.897802 2.88421 10.066 -28.0255 -2518 4 41.3077 16.0362 1.70176 -16.3219 -5.78099 30.2108 -2519 4 42.6299 16.1901 1.06805 12.6035 -3.11322 -2.97519 -2520 6 23.404 27.9303 27.4821 -1.06023 20.2241 -21.3645 -2521 4 22.8141 28.2554 28.1835 2.551 -1.87769 -8.73241 -2522 4 23.2629 28.4828 26.6516 2.17993 -16.4871 31.3925 -2523 6 32.7813 37.2936 18.7328 38.5641 -14.7697 6.75932 -2524 4 33.752 37.1016 18.9061 -34.9795 -0.437252 0.892363 -2525 4 32.8311 38.1729 18.3762 -6.70298 14.6722 -8.07554 -2526 6 21.2305 27.6771 4.7955 -18.4608 -25.795 -24.9287 -2527 4 20.5062 27.4644 5.39651 2.92048 5.31567 1.45057 -2528 4 20.941 27.2184 3.94502 12.5509 18.4099 23.8236 -2529 6 54.9409 17.9571 1.83459 -7.07205 6.42915 6.55936 -2530 4 54.7029 17.1381 1.42965 7.06691 -21.815 -7.49321 -2531 4 54.119 18.4405 1.74821 -9.38537 8.8513 -0.363257 -2532 6 36.7335 10.6984 6.58912 -34.5362 -0.324761 -4.53473 -2533 4 35.7609 10.9799 6.6143 34.1258 -12.1011 2.72213 -2534 4 36.7696 9.77633 6.90859 -3.13742 6.31851 -1.30765 -2535 6 54.2706 4.50024 14.0257 -11.269 5.99606 -15.4247 -2536 4 53.8536 5.11876 13.3604 4.87759 -11.992 26.1673 -2537 4 53.895 4.59469 14.9192 -3.76531 8.72829 -7.53187 -2538 6 22.107 12.8255 32.0148 27.0088 -6.82073 4.3703 -2539 4 21.2061 13.1328 31.8952 -10.7145 6.62508 -9.34344 -2540 4 22.7298 13.2576 31.3917 -17.4011 -3.99159 8.00208 -2541 6 15.2931 36.6619 4.04206 -24.4039 12.3238 20.1693 -2542 4 15.3606 37.6342 3.9855 6.08423 -9.62309 -2.22716 -2543 4 16.0243 36.2999 3.55051 12.1414 -1.28609 -8.9598 -2544 6 23.9518 1.27347 5.70825 1.82336 16.8815 15.3992 -2545 4 23.158 0.731739 5.71694 -5.31944 -7.03749 -3.2154 -2546 4 23.9846 1.73289 6.57368 -1.26671 -8.46254 -14.2674 -2547 6 14.3069 12.6571 15.8074 -11.3886 -13.8779 -22.9988 -2548 4 14.4908 12.4438 14.8835 17.1875 4.58775 1.43504 -2549 4 13.3991 12.3171 15.8566 5.60683 8.95198 18.2444 -2550 6 15.0463 40.2277 6.58272 -14.4539 15.1029 5.15073 -2551 4 15.8086 40.489 7.08192 22.3652 -6.01515 7.9389 -2552 4 14.4962 41.022 6.75392 -6.77819 -16.9793 -13.6053 -2553 6 48.5629 32.6194 12.091 2.37027 -5.84764 -3.4739 -2554 4 48.1048 31.8776 11.6348 7.57669 12.4587 1.43975 -2555 4 49.3373 32.9111 11.5511 -18.0393 -12.2542 5.39731 -2556 6 11.2883 31.5349 7.21941 -5.75599 -10.1169 -16.3625 -2557 4 10.675 30.8987 6.79271 12.7122 10.5617 8.56414 -2558 4 11.681 32.0415 6.48473 -4.52974 -6.63428 7.17241 -2559 6 30.1204 27.9925 10.216 2.65146 5.67665 0.571004 -2560 4 30.7332 28.7325 10.019 -7.63861 -11.6097 -0.594568 -2561 4 29.9063 27.5181 9.39417 2.857 4.22172 -1.33476 -2562 6 27.6817 22.1076 17.3717 2.13561 -8.21554 7.46684 -2563 4 27.3138 21.4721 16.7296 5.88092 9.15558 -3.1228 -2564 4 28.0594 22.8778 16.9197 -3.27829 -5.84867 -5.86393 -2565 6 12.9588 4.5965 18.1625 2.45174 -26.8216 -12.137 -2566 4 13.4346 3.75914 18.3684 -5.38503 16.4797 0.486183 -2567 4 12.5704 4.4145 17.2814 1.35975 11.1796 8.84538 -2568 6 19.7171 6.72206 19.0824 18.7149 18.1076 8.78634 -2569 4 19.0276 6.07043 19.1643 -12.8479 -14.7766 2.48779 -2570 4 20.149 6.78349 19.9504 -8.03044 -1.70313 -8.42964 -2571 6 37.158 31.386 11.4948 13.5333 -6.17925 -0.534196 -2572 4 36.3748 31.5241 12.0574 10.6691 -10.2998 8.4252 -2573 4 37.8298 30.7884 11.9154 -26.2348 9.80485 0.777976 -2574 6 3.12167 16.2038 27.3537 -19.2499 -26.3416 -14.9115 -2575 4 2.564 15.4232 27.613 17.9651 21.4634 -3.17821 -2576 4 3.05771 16.2343 26.3741 -0.0558506 5.44355 20.7735 -2577 6 15.7152 9.97508 38.3617 37.2659 20.4939 22.6587 -2578 4 16.1689 10.8384 38.1525 -17.0523 -25.976 5.55091 -2579 4 16.2475 9.64647 39.1327 -18.0975 2.21635 -20.7757 -2580 6 13.3945 14.2914 8.22355 52.7406 24.0557 20.8129 -2581 4 13.9343 15.0997 8.53617 -32.8018 -27.7376 -11.9171 -2582 4 14.0669 13.5802 8.35008 -24.0553 1.67412 -6.96019 -2583 6 1.72299 24.3133 36.3936 32.5837 -28.3335 21.1288 -2584 4 1.96116 25.1215 36.8464 -1.44419 12.4956 -1.11134 -2585 4 1.10799 24.5417 35.7277 -24.491 15.1488 -24.3141 -2586 6 11.1925 26.5189 32.9725 1.88857 3.23229 20.5962 -2587 4 10.9062 26.8258 32.1286 -6.138 -2.28585 -27.1412 -2588 4 11.0637 27.2989 33.5293 3.02186 -7.15206 7.83107 -2589 6 29.5898 0.769141 36.29 0.770047 10.6645 18.3277 -2590 4 29.1085 0.54227 35.5145 -3.81283 -13.529 -27.0487 -2591 4 28.8904 1.11515 36.8518 6.86702 4.29265 4.12775 -2592 6 43.6054 13.1224 23.9122 -2.46968 6.93561 -17.1322 -2593 4 42.8447 13.3401 24.4619 -4.47847 1.10283 0.728731 -2594 4 43.3126 13.2067 22.9653 4.50753 -0.208477 27.3689 -2595 6 7.45217 19.7807 19.6677 5.33955 -1.6221 -12.877 -2596 4 6.80427 19.1226 19.9251 -3.45906 -4.13396 8.35684 -2597 4 7.46466 19.745 18.7046 0.226191 5.91599 3.73904 -2598 6 24.4186 4.28854 7.83154 -9.27237 -3.93777 -5.86373 -2599 4 24.1141 5.19611 7.95791 2.72117 -5.11917 -0.666563 -2600 4 25.0574 4.07609 8.5187 1.73531 2.38301 -0.0162684 -2601 6 51.4783 30.2365 31.1578 4.43663 8.1051 17.8753 -2602 4 50.5719 29.9409 31.3316 -1.01079 -0.531629 -9.26743 -2603 4 51.6665 30.2531 30.2149 -6.58635 -1.64064 -12.0931 -2604 6 0.928618 23.6677 16.8891 39.1558 -2.20072 16.2176 -2605 4 0.0728448 23.4362 16.5368 -6.93512 -13.3273 -6.91209 -2606 4 1.45563 22.867 17.1505 -20.9828 13.2836 -9.64814 -2607 6 45.0876 19.3948 15.692 7.86589 27.8079 -34.4593 -2608 4 45.9117 18.9264 15.546 6.38244 -8.87865 2.87525 -2609 4 44.6429 18.9609 16.3882 -19.7965 -22.2098 30.8606 -2610 6 17.4975 8.71947 40.5884 -15.3884 33.6574 -8.04213 -2611 4 18.1832 9.38307 40.741 -0.0730079 1.31818 -0.306908 -2612 4 17.9142 7.90906 40.8182 15.4372 -26.466 6.58932 -2613 6 30.1853 27.2566 27.195 -12.9952 17.3445 1.1523 -2614 4 31.1231 27.467 27.0889 -0.851996 0.391463 0.93648 -2615 4 29.6983 28.1205 27.2412 18.1484 -22.709 -4.59112 -2616 6 43.0643 26.2027 28.3545 -5.31946 22.0639 -20.7107 -2617 4 43.281 25.753 27.5201 1.76973 -3.45008 6.18356 -2618 4 43.0898 25.5645 29.0616 2.35339 -12.574 6.70826 -2619 6 27.9963 7.58777 3.05558 10.5798 9.34284 19.8534 -2620 4 28.0446 6.83168 2.47717 -2.58104 -14.3156 -10.0889 -2621 4 28.509 7.35692 3.86128 -6.64638 2.01122 -8.68086 -2622 6 44.6822 7.22369 10.1895 -15.4824 21.4485 13.7445 -2623 4 44.4465 7.45383 11.1264 7.27839 -9.51736 -18.1425 -2624 4 45.2115 6.42757 10.2073 4.94307 -7.89984 8.76143 -2625 6 23.5336 20.3897 32.2571 -4.86538 -1.36788 -16.1605 -2626 4 23.3032 21.2113 32.7104 1.28111 0.523216 5.34569 -2627 4 23.9774 19.8232 32.8948 2.81274 0.218846 6.19737 -2628 6 37.5478 21.0473 29.278 -18.5062 7.79735 6.57819 -2629 4 37.2371 20.358 28.6908 4.72073 -14.165 -12.1471 -2630 4 36.7158 21.4163 29.628 13.2175 4.90017 2.66375 -2631 6 49.286 29.0703 28.699 10.8186 8.22027 -9.31733 -2632 4 48.7028 29.7991 28.456 -10.3299 -0.414367 -0.610456 -2633 4 50.1517 29.4276 28.433 0.637469 -9.81751 4.99071 -2634 6 47.52 18.1671 15.2208 -2.7229 30.7912 -34.1138 -2635 4 48.0078 17.7317 15.8928 12.2019 -13.0526 25.5862 -2636 4 48.0044 19.0008 15.0204 -10.6208 -16.322 3.06818 -2637 6 23.2448 11.1727 16.5931 -14.8157 -11.6244 -0.308602 -2638 4 23.8342 11.8286 16.2582 11.4387 21.3683 -6.30591 -2639 4 23.6559 10.3501 16.3116 -3.14365 -5.23997 2.15847 -2640 6 3.13911 8.33446 23.1963 -2.69702 8.14317 3.16076 -2641 4 3.4034 7.82956 22.4196 3.11719 -1.75335 -2.44085 -2642 4 3.61355 9.18537 23.1574 -2.855 -3.87959 1.25156 -2643 6 0.502965 16.1866 6.18545 3.06312 3.24934 37.7622 -2644 4 1.47856 16.2897 6.04903 -24.0003 -4.70784 4.68468 -2645 4 0.309706 16.1237 7.18858 13.4295 2.89967 -42.1744 -2646 6 43.1771 15.7066 5.83749 -5.07319 -7.51407 -5.60477 -2647 4 43.0136 16.4204 6.43488 -7.5966 11.2789 14.4199 -2648 4 44.0623 15.8898 5.5251 15.5631 0.134699 -7.60204 -2649 6 16.7019 35.4798 34.4572 -11.2013 7.16284 28.6023 -2650 4 15.9782 34.9492 34.0738 5.35466 1.61493 8.45244 -2651 4 16.3895 35.7941 35.362 6.52255 -9.83405 -29.4813 -2652 6 38.8822 7.74245 15.6771 24.467 26.2162 11.5837 -2653 4 39.1941 7.06316 15.0707 0.325231 -3.95447 -5.25413 -2654 4 39.6937 8.2709 15.9758 -30.2905 -22.5291 -12.0432 -2655 6 42.0043 36.5204 13.6369 3.57579 19.2035 0.0265624 -2656 4 41.9371 35.5667 13.6578 -6.58441 -9.91584 1.38486 -2657 4 41.1548 36.8737 13.3269 0.670997 -7.61264 0.497391 -2658 6 54.2965 15.3698 32.1203 7.94984 -1.57724 11.6593 -2659 4 0.00278476 15.9714 32.4364 -1.97539 -6.90512 -0.0853595 -2660 4 53.6257 15.9484 31.7567 -4.83125 0.736868 -4.95397 -2661 6 22.8953 13.994 39.0277 29.317 0.766946 3.70607 -2662 4 23.2673 14.8115 39.3939 -3.87119 -6.48985 -1.20924 -2663 4 21.9724 14.1463 38.894 -27.0425 2.87882 -4.26486 -2664 6 48.0413 28.5291 4.79053 -11.6037 -2.58599 22.6989 -2665 4 48.6027 28.7991 4.07655 16.555 3.34212 -19.6439 -2666 4 47.7045 29.3636 5.15455 0.064426 -0.719185 3.47056 -2667 6 48.8324 10.6079 2.66689 -4.06073 -3.45613 -38.269 -2668 4 48.225 10.1372 3.21562 -13.339 -11.2438 14.6703 -2669 4 49.3888 11.1314 3.20945 16.7197 17.33 23.918 -2670 6 17.1017 29.3417 4.42129 -6.1746 1.2215 19.6287 -2671 4 16.2515 28.9749 4.73431 4.06151 0.983408 -5.41825 -2672 4 17.5169 29.7258 5.22535 1.37581 -6.66399 -13.2687 -2673 6 27.7925 7.31966 26.5665 39.3465 35.5797 -5.30427 -2674 4 28.7629 7.09708 26.703 -34.5848 -6.71948 -0.628584 -2675 4 27.2286 6.57009 26.6643 -1.86949 -31.2701 4.24572 -2676 6 18.0221 22.0409 22.5172 -16.5701 10.2349 -21.3339 -2677 4 18.5639 21.2383 22.5163 -1.8186 -3.43948 -8.36361 -2678 4 17.5144 22.1102 21.6408 22.068 -10.0871 32.2991 -2679 6 22.1395 25.0891 16.7042 -20.9036 23.9116 7.05274 -2680 4 21.7854 25.6501 15.9625 11.5166 -19.4533 18.3362 -2681 4 22.5191 24.3092 16.3181 5.92374 -8.20656 -11.3677 -2682 6 25.488 28.4523 7.12785 -10.8823 -15.9396 20.8595 -2683 4 25.4981 28.5494 8.12476 3.48758 8.16016 -33.1398 -2684 4 25.5521 29.3092 6.69674 -1.4246 11.8198 7.49476 -2685 6 42.5416 24.7341 23.7389 -17.4504 20.5814 2.46415 -2686 4 41.7374 25.1978 24.1118 21.637 -12.0739 -8.95046 -2687 4 42.3838 23.7928 23.8344 -7.43983 -12.597 1.84916 -2688 6 6.22002 16.6178 2.47863 15.1987 22.5956 5.3052 -2689 4 5.33799 17.0017 2.41879 -13.1624 -14.3434 -0.0608379 -2690 4 6.24934 15.6649 2.55192 -10.5885 -12.312 -0.729605 -2691 6 47.3735 33.281 1.45237 -1.26376 -9.34891 -34.4477 -2692 4 47.004 34.1558 1.53803 -0.151384 8.42018 6.19826 -2693 4 47.7374 33.0316 2.29181 5.29029 2.56444 17.845 -2694 6 1.28124 36.1882 24.8833 15.6174 10.404 -23.7919 -2695 4 0.591937 36.4933 25.4703 -7.67557 -4.15788 11.0948 -2696 4 1.63511 35.375 25.2549 -3.92235 -3.89482 10.8998 -2697 6 20.9296 29.0485 16.4244 -14.8946 8.72798 0.140185 -2698 4 21.4494 28.4837 15.8729 6.14594 -21.5718 -11.6475 -2699 4 21.5122 29.7657 16.643 5.64358 11.2813 6.66084 -2700 6 18.6504 32.5428 14.1464 30.5599 1.70581 -2.73789 -2701 4 17.8579 33.056 14.2705 -20.3424 -4.20043 8.80032 -2702 4 18.5989 31.5954 14.3835 -16.0449 10.8642 1.76069 -2703 6 15.729 41.6925 0.00385817 -5.28292 -15.868 -0.0471225 -2704 4 15.6317 41.084 41.1283 -1.722 11.921 23.9575 -2705 4 15.1873 41.3899 0.782005 8.67232 1.52126 -23.9336 -2706 6 20.5292 18.4098 7.21323 -2.91221 4.89049 5.17577 -2707 4 20.2914 18.5583 8.16487 -5.028 -0.721877 -18.2737 -2708 4 19.7413 18.3526 6.62958 8.30767 0.291632 18.8261 -2709 6 35.3342 2.82915 1.61883 3.51298 26.3767 19.1091 -2710 4 35.0331 3.19583 2.50754 16.3791 -7.36031 -35.2043 -2711 4 35.9206 3.53855 1.22039 -16.4006 -18.5858 14.5973 -2712 6 48.9922 19.6721 24.94 -34.075 0.0390245 -1.22883 -2713 4 49.8199 19.2352 24.7823 16.5976 -0.114011 -0.96393 -2714 4 49.1617 20.6125 25.0649 5.94448 -3.86752 4.03728 -2715 6 26.0294 7.18427 41.5679 18.6543 -22.0446 -14.9111 -2716 4 26.7755 6.56315 41.735 -11.6555 11.6244 -4.08136 -2717 4 25.6575 7.3193 0.515359 -11.3234 5.2253 22.1616 -2718 6 22.0232 3.61039 29.0191 -5.74486 -2.38085 -7.46091 -2719 4 21.2539 3.82496 28.4513 11.98 3.27859 6.66273 -2720 4 22.2148 4.35673 29.5966 -4.60401 3.08527 0.791206 -2721 6 27.8512 32.5337 20.6565 16.709 -10.0789 14.6393 -2722 4 26.9625 32.7469 20.4552 -34.4793 1.21347 -3.16249 -2723 4 28.3469 33.1233 20.1026 12.1012 5.18966 -5.24336 -2724 6 8.41229 24.7869 3.46082 22.3386 15.1563 9.53263 -2725 4 8.90357 24.2552 2.84068 9.55631 -8.44952 -10.853 -2726 4 7.60423 24.3318 3.61908 -22.8615 -12.1417 2.22131 -2727 6 30.5897 41.7312 15.6484 22.6974 7.2585 28.5546 -2728 4 29.9644 0.0840213 16.3484 1.9076 -3.76769 -8.41354 -2729 4 30.1014 41.5664 14.8669 -20.7398 -7.21626 -25.2002 -2730 6 48.088 5.62638 21.1953 6.60529 -8.20232 0.106871 -2731 4 47.6746 6.34733 20.7055 -8.23977 -5.05625 1.96425 -2732 4 47.4017 5.06013 21.5879 -0.150274 10.975 -6.21391 -2733 6 39.4216 23.1741 35.7526 -24.6601 -13.9913 -21.1364 -2734 4 39.9113 23.6202 36.3986 28.8985 24.9348 33.8823 -2735 4 38.8958 22.5444 36.2533 -4.57276 -5.65639 2.90172 -2736 6 51.5794 33.3637 5.78804 -15.2387 -43.0642 -16.4958 -2737 4 51.7543 34.264 5.94613 8.32006 43.2545 8.99501 -2738 4 51.5314 33.243 4.82206 1.27667 3.09716 8.04215 -2739 6 40.1245 17.6149 30.7901 8.56984 -3.86721 -1.09973 -2740 4 39.7659 18.4612 31.0527 -2.58034 0.199434 5.42908 -2741 4 40.7245 17.8709 30.0792 -0.880063 -10.8459 -3.09375 -2742 6 46.409 9.80599 18.5787 -10.6525 10.5445 16.3312 -2743 4 47.1858 10.3579 18.4839 1.73901 1.20814 1.97642 -2744 4 46.4156 9.2339 17.8265 -1.18405 -17.3223 -19.0152 -2745 6 15.8964 41.084 31.9275 -7.67529 -16.3413 6.36199 -2746 4 16.5726 40.6297 31.3851 0.744388 15.1086 2.48527 -2747 4 16.0838 0.121849 31.9545 10.6182 0.477469 -6.79561 -2748 6 48.5579 25.7373 14.9245 -32.9201 0.62376 14.4593 -2749 4 49.4842 25.8337 14.7718 19.5896 2.21134 -17.0603 -2750 4 48.049 25.8802 14.1037 15.4245 2.93063 1.46628 -2751 6 39.2312 28.9787 36.1455 -14.672 -4.00104 3.01304 -2752 4 39.9934 29.3216 36.628 6.25522 6.25199 -7.03146 -2753 4 39.4638 28.7366 35.2366 10.4577 0.0924929 -3.6403 -2754 6 37.3289 21.0516 14.9314 -10.8689 -7.09111 1.49701 -2755 4 38.071 20.892 14.3011 -28.0288 10.0477 -1.14031 -2756 4 36.4673 21.3942 14.5393 36.2132 -8.93414 7.14583 -2757 6 32.4934 22.8531 15.7417 3.10645 -11.4389 20.7178 -2758 4 31.7266 22.539 15.2235 4.17967 -1.79737 6.20971 -2759 4 32.6084 22.2825 16.5528 -7.19864 12.5613 -26.7488 -2760 6 18.5678 8.15053 37.5885 12.1963 17.253 1.38788 -2761 4 19.2402 8.85275 37.7813 -15.6951 -12.294 2.78452 -2762 4 17.9606 8.11124 38.3342 2.60008 5.05619 4.87993 -2763 6 46.9436 30.3797 11.0104 1.88703 -1.83756 -2.66296 -2764 4 46.4577 30.6986 10.2121 16.8565 -15.5671 12.8865 -2765 4 47.4104 29.5424 10.7815 -11.8828 15.01 -3.66074 -2766 6 54.6316 13.0448 30.6676 -4.47091 -6.8042 2.85617 -2767 4 54.8929 12.2323 31.1402 -1.2342 7.60269 0.15722 -2768 4 54.6603 13.771 31.309 -0.297949 0.849652 -1.52079 -2769 6 32.2951 35.1224 27.9786 -1.77947 21.9995 15.3623 -2770 4 32.2792 35.8643 28.662 -2.01418 -27.5067 -15.3374 -2771 4 32.1621 34.2527 28.3767 0.559318 -0.0892981 14.8897 -2772 6 4.45055 25.4036 31.7899 -1.02142 -16.2715 16.4968 -2773 4 4.99753 24.9958 32.4777 -6.33224 -6.47315 3.67169 -2774 4 4.91071 26.2154 31.6821 9.55032 31.2277 -12.9728 -2775 6 40.7771 38.1434 21.8579 6.80518 1.6634 -4.63259 -2776 4 40.7449 39.0581 22.1203 -10.5616 15.8809 15.9679 -2777 4 41.4448 38.2055 21.1733 6.63637 -13.627 -11.1518 -2778 6 26.6799 9.85647 27.3982 -25.6987 30.8747 18.2417 -2779 4 27.0738 9.12687 26.9584 7.64189 -30.2216 -11.3166 -2780 4 25.7862 9.62595 27.7363 13.5029 -2.01996 -6.34848 -2781 6 53.4177 39.431 11.7682 60.4327 6.90374 -14.3662 -2782 4 54.4363 39.4906 11.5459 -51.7213 -2.15349 13.0324 -2783 4 53.0514 40.2823 11.4531 3.65586 -10.6921 6.91198 -2784 6 35.3318 21.4177 2.24537 5.41769 -12.1321 -20.1082 -2785 4 34.8431 20.6225 2.51379 1.47903 7.83344 1.83382 -2786 4 35.7036 21.1864 1.3528 -11.9529 6.47568 24.5243 -2787 6 4.13637 17.136 33.9211 3.37621 -12.3766 5.67686 -2788 4 4.20441 16.396 34.5697 -7.88327 11.3141 -11.775 -2789 4 3.23668 17.1493 33.5445 4.32036 -6.23827 5.33579 -2790 6 24.1551 16.173 14.6595 0.905264 -13.203 -15.7913 -2791 4 24.2344 17.0724 14.9677 3.21898 8.1818 3.14137 -2792 4 23.7074 16.2777 13.8038 1.81958 -4.41422 2.08172 -2793 6 43.135 2.84466 26.1032 13.1229 6.35408 -5.68313 -2794 4 42.2875 3.17639 26.414 -4.49653 4.08553 -4.30298 -2795 4 43.2684 3.17059 25.1875 -5.24638 -3.17663 12.7173 -2796 6 40.6938 12.184 1.56501 -11.5288 -7.07153 -25.6549 -2797 4 41.6237 12.1687 1.8186 -0.151998 5.09311 17.9246 -2798 4 40.0653 12.4844 2.24465 11.7671 0.703669 4.7582 -2799 6 47.3771 8.09383 26.755 61.1653 27.2124 16.0462 -2800 4 46.6352 7.69428 26.3774 -33.8593 -24.2939 -29.8281 -2801 4 48.1554 8.02079 26.1437 -24.5213 -4.41693 14.2109 -2802 6 35.8722 30.7298 38.4929 46.7797 8.20249 -0.795626 -2803 4 35.8437 29.9971 39.0885 -23.8052 -20.0767 8.1402 -2804 4 36.8495 30.8926 38.5637 -31.083 11.8011 -18.5205 -2805 6 51.2951 23.2205 32.4921 -21.4102 17.5258 -2.96787 -2806 4 51.6315 24.0445 32.1105 -0.705735 5.94923 -0.836877 -2807 4 52.0737 22.714 32.6486 16.7198 -16.4886 4.04233 -2808 6 30.6141 4.4461 39.6711 -15.3731 3.79473 -35.0115 -2809 4 30.9464 3.61986 40.0176 9.77962 -4.83986 19.2734 -2810 4 30.7704 5.18568 40.2576 9.11216 5.26318 14.244 -2811 6 35.2646 29.7051 2.85778 -14.8887 -12.395 -20.7058 -2812 4 35.7986 29.7272 2.02588 -11.2321 -1.99949 14.2373 -2813 4 34.4405 29.1492 2.64359 32.9241 21.0754 6.44042 -2814 6 50.3111 26.1454 9.40098 -22.1621 10.9454 -20.0185 -2815 4 49.986 26.7793 8.71172 15.2241 -16.6208 13.1315 -2816 4 49.7063 25.388 9.31525 11.793 4.08785 3.97386 -2817 6 50.0869 36.8245 26.4088 -20.9012 -6.38176 7.71076 -2818 4 49.5586 36.0705 26.7514 3.9746 5.79943 -8.74909 -2819 4 50.1941 37.3864 27.1871 4.41306 8.36789 0.548966 -2820 6 40.3119 23.9565 38.5384 47.4279 -1.39254 -15.5521 -2821 4 40.88 24.732 38.748 -21.3925 -13.0784 -2.40019 -2822 4 39.4343 24.1145 38.8527 -20.1214 13.5622 11.7594 -2823 6 24.9444 10.7496 30.6663 31.051 18.5451 27.0394 -2824 4 25.7305 10.8456 31.2787 -28.4 -7.1047 -26.2292 -2825 4 24.8995 11.6269 30.2371 -7.15612 -14.1049 -2.61146 -2826 6 5.89131 1.01728 5.39947 -5.16247 -17.9253 -0.227043 -2827 4 5.22088 0.340863 5.59281 2.49468 7.88844 1.50452 -2828 4 6.71299 0.544267 5.57411 4.99832 4.76302 -4.28882 -2829 6 44.2927 29.3807 26.2764 43.728 -18.4205 -0.18667 -2830 4 43.5018 29.5461 25.816 -39.4067 7.83222 -12.62 -2831 4 44.7851 28.7616 25.699 -3.50466 6.32584 16.51 -2832 6 25.3064 10.1814 6.6654 -6.94402 -15.718 -9.61204 -2833 4 25.6542 11.0594 6.61048 6.10034 18.8978 1.37462 -2834 4 25.5624 9.77067 5.8255 0.943829 -2.29537 1.40094 -2835 6 13.3606 28.0664 2.58456 21.0736 -2.27515 1.79417 -2836 4 12.4645 27.8304 2.42125 -25.9451 -0.745297 2.44011 -2837 4 13.7867 27.7237 1.79619 10.8353 3.06046 3.23802 -2838 6 6.45257 40.24 18.0133 20.0379 8.33657 1.98834 -2839 4 6.89988 39.3931 17.8777 -5.14522 -3.62214 0.392952 -2840 4 5.56311 40.1207 17.6969 -15.0406 -3.82351 -6.06839 -2841 6 47.8011 13.5056 2.01844 -10.5648 -21.267 23.3214 -2842 4 48.1524 12.6081 2.17165 -2.87721 6.43796 -2.24674 -2843 4 48.4275 13.9546 1.48105 20.9852 11.6376 -18.273 -2844 6 13.5939 20.3067 2.43603 17.8956 14.689 14.157 -2845 4 13.8339 19.6256 3.09172 -4.40777 3.66463 -6.9739 -2846 4 12.9598 19.9059 1.86118 -14.8369 -10.3601 -11.305 -2847 6 15.2334 0.8368 36.6591 1.55142 7.70692 -22.3998 -2848 4 15.2542 1.38367 37.4773 0.960764 -3.32816 -20.1037 -2849 4 15.3344 1.45306 35.8608 -4.23652 -17.7771 37.8382 -2850 6 33.6147 35.2459 15.1 16.7734 -11.8793 -18.4599 -2851 4 33.8163 35.2873 16.0538 13.2499 -3.34836 -12.9991 -2852 4 34.4154 34.9808 14.5294 -23.6504 9.8312 34.8639 -2853 6 21.8005 9.23588 0.431159 13.8262 -19.7524 30.0596 -2854 4 22.4067 9.05801 41.6249 5.27322 -0.932182 -12.5411 -2855 4 21.1072 9.74412 0.0564903 -22.836 18.1195 -16.0408 -2856 6 38.1565 27.4627 3.04439 18.4183 -28.2807 7.84104 -2857 4 37.7322 27.3164 2.21113 -4.60599 -14.2952 -24.3043 -2858 4 37.7632 28.2451 3.34335 -13.6136 36.2365 19.5187 -2859 6 38.8873 27.196 11.7739 15.5044 -8.33717 -5.93911 -2860 4 38.7841 26.3327 12.232 6.37868 6.61944 -11.5261 -2861 4 39.5786 27.1133 11.0659 -17.5863 -8.28826 19.2684 -2862 6 29.8757 41.5959 28.7066 13.5858 28.49 -11.3766 -2863 4 28.9647 41.3014 28.7466 -9.40406 -2.02578 1.88502 -2864 4 29.8997 0.254331 27.9025 -2.68961 -11.7418 13.302 -2865 6 34.0266 8.72323 38.0698 33.719 9.40995 4.6971 -2866 4 34.8877 8.24089 38.094 -11.378 13.1352 -1.62724 -2867 4 33.3712 8.08689 37.8245 -20.4874 -15.945 -8.86187 -2868 6 38.8142 27.3472 30.6886 -7.48306 -22.0573 -0.58069 -2869 4 38.4096 26.5151 30.3537 9.19692 16.3236 1.53567 -2870 4 38.2655 27.5885 31.4334 -4.0026 6.56393 5.14207 -2871 6 41.6513 17.2644 36.3568 8.49285 18.5772 4.12306 -2872 4 41.236 17.1887 35.5016 -7.55839 -3.54967 -10.3568 -2873 4 41.7813 16.3888 36.7033 1.22956 -17.0266 1.65102 -2874 6 30.7157 26.9788 35.2038 -10.151 -4.28381 0.0670681 -2875 4 31.4488 27.4236 34.7965 20.0965 0.384289 -13.2747 -2876 4 30.343 27.6484 35.7639 -8.80839 6.96039 12.3672 -2877 6 47.5342 4.10778 27.2888 11.6095 8.93875 26.3727 -2878 4 46.6105 4.27591 27.501 -8.38331 -0.425724 -4.8003 -2879 4 47.5988 3.99389 26.3497 -6.2541 -0.220522 -17.1995 -2880 6 20.9412 8.38521 7.26575 -18.1268 -17.2637 2.68033 -2881 4 20.8809 8.87169 8.08328 -6.592 1.96128 21.9757 -2882 4 21.4179 8.98778 6.73029 19.5174 18.1449 -30.7672 -2883 6 36.8608 13.6781 0.872276 -22.567 18.0135 -7.8322 -2884 4 37.3857 13.5342 1.64823 18.2236 -14.2068 17.6988 -2885 4 36.9649 12.9376 0.269125 7.56106 -9.0363 2.17502 -2886 6 28.5805 20.3012 26.4498 13.4935 0.222411 -13.7489 -2887 4 28.4835 19.3803 26.2016 0.90122 -3.21423 2.30104 -2888 4 27.7964 20.5416 26.9224 -18.5183 5.12398 12.3317 -2889 6 51.6021 16.8515 33.5179 -11.2544 -15.3 0.627003 -2890 4 51.563 16.0241 34.0301 0.916298 4.09207 -0.753195 -2891 4 51.0058 16.6639 32.7753 6.31462 4.20327 -0.345536 -2892 6 16.2626 32.019 37.6812 -31.2107 -29.2496 -22.9287 -2893 4 16.4537 31.3803 38.4011 -2.23747 12.829 -12.3594 -2894 4 15.5373 31.5705 37.1079 31.9743 21.1891 23.5065 -2895 6 14.3366 25.8859 13.2055 -16.2598 35.1345 -7.65407 -2896 4 13.5591 26.1022 13.7538 4.79106 -9.45955 4.66587 -2897 4 14.3924 26.7004 12.6499 8.67511 -16.0651 4.90492 -2898 6 54.9632 28.863 3.30225 1.80665 -46.0259 4.02989 -2899 4 54.8334 28.8705 2.33571 2.30679 -1.29159 7.0988 -2900 4 0.250446 27.9134 3.53944 -11.9885 37.0888 -10.0107 -2901 6 17.2065 5.13222 2.58226 -24.5489 -19.7693 -14.9516 -2902 4 17.8239 4.45011 2.8785 5.4716 1.45995 5.40018 -2903 4 17.4096 5.93537 3.0482 10.2082 3.99522 6.08435 -2904 6 50.7076 33.0524 10.3335 3.48719 10.0002 9.95533 -2905 4 50.6136 33.804 9.75033 0.0726689 14.8217 2.89741 -2906 4 50.6632 32.3255 9.72979 -1.7797 -23.5385 -6.20373 -2907 6 28.8719 19.8379 32.3662 12.2168 9.43689 -9.94144 -2908 4 29.8293 20.0527 32.223 -26.7315 -2.75674 4.09206 -2909 4 28.3919 20.677 32.2058 6.96369 -8.55206 2.54368 -2910 6 22.4258 12.8301 23.3099 -21.9068 12.8519 23.6974 -2911 4 22.5424 12.4187 24.2055 -3.2327 9.70973 -17.8182 -2912 4 21.6904 13.4906 23.4219 18.0295 -16.5223 -3.23075 -2913 6 54.7859 15.5473 8.87871 3.42684 8.57095 -7.37477 -2914 4 0.5152 15.244 9.45304 -3.41058 -4.28924 6.32649 -2915 4 53.9742 15.1056 9.16818 6.16615 -2.4265 3.01646 -2916 6 10.455 19.2982 26.169 33.281 -8.93788 40.2277 -2917 4 11.227 18.6906 26.1605 -15.5014 12.2348 -4.03004 -2918 4 10.0694 19.2521 25.3251 -19.4777 -1.76614 -41.28 -2919 6 38.6541 20.3016 35.2246 25.1317 -2.89776 0.584273 -2920 4 39.6122 20.389 35.0245 -16.8563 1.20482 1.7302 -2921 4 38.6037 19.6498 35.9401 -3.42784 5.37932 -3.92632 -2922 6 17.4847 18.0451 15.2473 -2.11698 43.6037 15.5575 -2923 4 17.3165 17.6253 14.4157 -4.81229 -12.7227 -25.2707 -2924 4 17.3243 19.0143 15.0283 6.45297 -29.0578 8.37137 -2925 6 29.6412 0.96029 26.2538 -2.92598 -32.1867 -14.968 -2926 4 29.2295 1.80722 25.9783 -5.05853 -19.2177 -5.0061 -2927 4 29.2302 0.136786 25.7855 11.2507 47.838 14.1271 -2928 6 30.4583 12.6781 28.2933 9.80318 -11.3268 12.128 -2929 4 29.9046 13.1756 27.6811 -9.35495 -4.05719 -6.55314 -2930 4 30.1425 11.7563 28.3949 -4.92949 12.905 -7.65094 -2931 6 36.6582 22.1039 33.3564 18.5548 3.44171 -30.7077 -2932 4 37.613 21.8793 33.4826 -21.695 5.78572 4.26475 -2933 4 36.1698 21.8632 34.1249 -2.38139 -6.6943 29.4942 -2934 6 34.851 22.4634 14.295 34.3706 -12.4795 -36.6647 -2935 4 34.1306 22.5878 14.8998 -26.9044 -0.864951 1.69223 -2936 4 34.6097 22.0485 13.4154 -10.7342 10.9778 31.0087 -2937 6 15.5278 9.60588 7.43972 42.9889 -30.8008 -13.2318 -2938 4 16.5289 9.52064 7.17624 -51.4641 3.68278 11.9177 -2939 4 15.1523 8.68078 7.51431 10.3517 24.0811 1.24627 -2940 6 21.8097 28.0449 19.8036 -9.3837 2.2861 -3.69714 -2941 4 21.8234 28.4749 20.6579 1.49564 5.45585 8.79124 -2942 4 20.892 27.7474 19.715 3.3935 -2.50466 0.747966 -2943 6 34.5377 24.4067 2.43307 17.6783 -35.0943 7.08511 -2944 4 34.5604 23.3833 2.29911 9.6022 45.0517 12.0591 -2945 4 35.2671 24.6922 3.07368 -22.5652 -15.0324 -19.8681 -2946 6 12.5974 20.9324 33.5156 -46.2472 -18.3539 -4.34371 -2947 4 11.7028 20.621 33.8238 24.9199 8.0821 6.3307 -2948 4 12.4411 20.8933 32.5604 17.1824 5.4367 5.76912 -2949 6 45.7726 31.1546 8.70236 -14.9606 25.5026 -0.599968 -2950 4 45.9029 32.1319 8.75243 4.68257 -18.3747 -3.63409 -2951 4 44.8252 31.0158 8.86685 6.58294 -2.27884 -1.49072 -2952 6 15.4856 22.546 30.183 -27.3843 -7.95278 -8.87715 -2953 4 16.2041 23.1276 30.4314 15.0704 -4.03687 4.09321 -2954 4 15.7065 21.6006 30.174 10.2057 11.8959 3.83923 -2955 6 39.7496 17.1848 38.4183 10.7213 7.86871 6.49434 -2956 4 39.4778 16.5926 37.6964 5.17631 5.73732 3.80123 -2957 4 40.5328 17.6892 38.1152 -12.3514 -12.5856 -1.70264 -2958 6 14.0114 24.6894 0.67727 2.36324 3.45559 -2.63023 -2959 4 14.2236 24.5974 1.61702 0.728832 5.12592 -0.706901 -2960 4 14.3876 25.5307 0.374588 3.08684 -2.75846 6.71077 -2961 6 31.517 19.5744 3.57234 -39.7066 16.7987 -9.47084 -2962 4 30.9812 19.3042 4.35775 22.6375 1.42354 -10.5596 -2963 4 32.4299 19.3292 3.64982 19.3858 -12.3464 7.87151 -2964 6 36.0836 25.0594 19.4567 -36.7914 6.39304 28.0525 -2965 4 37.0156 25.1955 19.4145 23.7106 3.97855 -3.98164 -2966 4 35.8434 24.7134 18.6052 0.797557 -6.28507 -17.3783 -2967 6 51.6689 17.6827 14.8094 17.1445 12.5774 26.8045 -2968 4 51.9037 18.5572 15.2299 -9.72171 -22.1194 -12.5657 -2969 4 51.1779 17.9239 14.0295 -8.26923 9.08158 -15.405 -2970 6 37.7112 27.5006 38.1887 12.9616 35.4771 9.449 -2971 4 37.6633 26.7956 37.5532 1.11487 -12.4995 -15.1422 -2972 4 38.1924 28.2458 37.7567 -11.1334 -22.4905 3.32353 -2973 6 34.7974 13.8528 30.7792 38.2139 14.8122 -13.8353 -2974 4 35.0479 14.6237 31.2931 10.1718 6.91547 -1.09557 -2975 4 34.0108 13.6012 31.1887 -47.9834 -23.6229 17.9792 -2976 6 19.6227 37.378 39.9679 -4.73731 -6.94245 -18.3615 -2977 4 20.5687 37.4692 40.1123 7.88808 5.09103 7.87528 -2978 4 19.5641 36.8976 39.1176 -6.21843 3.50671 7.67834 -2979 6 40.9479 34.0678 21.4433 -0.249567 -14.1225 -18.8789 -2980 4 41.1016 33.9428 22.3797 -2.14769 -1.67588 5.36328 -2981 4 40.6839 33.1793 21.1286 -1.36491 12.9737 -0.808456 -2982 6 32.9563 27.2052 26.5619 16.765 25.3633 38.6423 -2983 4 33.6584 27.782 27.0193 -28.2502 -21.1678 -18.3317 -2984 4 33.3196 26.985 25.7164 10.2198 -2.00428 -21.725 -2985 6 24.4119 18.6722 15.6191 2.60565 2.56356 0.790403 -2986 4 23.5591 19.1036 15.7005 -5.06369 4.62453 -0.705819 -2987 4 24.5532 18.2558 16.4735 3.02917 -4.75652 8.16225 -2988 6 29.9677 1.63803 9.07283 -8.6377 39.5876 -9.34009 -2989 4 30.0634 0.720354 9.20948 2.18912 -36.9171 5.61628 -2990 4 29.1461 1.70687 8.54641 9.48634 -0.985828 6.78106 -2991 6 31.4838 20.0989 7.86304 35.53 0.0326438 -30.7549 -2992 4 32.0429 19.6076 7.17649 -26.3889 9.76992 30.1887 -2993 4 30.8408 19.4752 8.19414 -7.49558 -12.7978 -1.24617 -2994 6 35.0504 3.77818 33.2765 0.0823497 -0.922868 12.9261 -2995 4 34.3448 4.25588 32.7981 8.7563 -3.59111 2.91721 -2996 4 34.8655 3.9194 34.2319 -2.64551 -3.11561 -17.2257 -2997 6 43.9652 7.96842 12.9746 -1.99776 -12.8019 0.966431 -2998 4 43.3695 7.30717 13.3748 13.3395 3.08022 -2.86187 -2999 4 43.3917 8.71398 12.8108 -3.39849 12.2944 -1.42541 -3000 6 44.1076 32.6848 16.9531 4.83347 14.0385 -4.8226 -3001 4 44.7886 33.3699 16.7553 -9.08835 -13.3706 7.91806 -3002 4 44.1269 32.547 17.9059 1.63547 3.97279 4.50154 -3003 6 40.604 27.1617 19.037 5.49217 0.683783 -24.0967 -3004 4 39.907 26.5243 18.7614 10.7357 10.4426 0.818988 -3005 4 41.0572 27.5561 18.2306 -16.7517 -14.1941 23.9583 -3006 6 46.0503 23.2068 29.0603 33.2935 27.7725 23.492 -3007 4 46.7239 23.8517 29.4252 -26.0483 -15.0892 -12.6312 -3008 4 46.5249 22.3737 28.9794 -1.25341 -9.22801 -2.13192 -3009 6 42.6264 30.606 18.8462 -34.271 -0.881878 -8.8004 -3010 4 43.5242 30.7893 19.1074 18.3218 -5.88078 -5.57768 -3011 4 42.5428 29.9264 18.1492 10.4183 2.57162 5.03187 -3012 6 36.1231 10.8975 23.2614 14.248 33.6052 6.96597 -3013 4 35.2264 11.248 23.1278 1.11349 -2.62395 -2.03304 -3014 4 36.6438 11.7125 23.5215 -18.5882 -27.5405 -10.5609 -3015 6 13.7387 31.5187 15.7175 -8.63655 -3.85126 -4.64142 -3016 4 14.6788 31.7096 15.8046 0.813603 4.25462 -2.48371 -3017 4 13.3439 32.0503 15.0041 7.14664 -1.81478 4.34843 -3018 6 33.1663 41.4263 27.7844 10.1514 -8.73892 50.1834 -3019 4 33.0558 0.0915148 27.0508 0.335607 20.6114 -25.4934 -3020 4 33.386 0.0476391 28.6 -4.59167 -12.6797 -24.4066 -3021 6 32.8924 22.9248 31.4777 14.8331 -14.2772 -3.0724 -3022 4 32.331 22.9976 30.6823 -4.11553 14.0534 8.76104 -3023 4 32.7731 23.648 32.1168 -12.639 5.72297 -14.9522 -3024 6 27.6514 16.8629 6.392 5.9792 -3.02818 28.7598 -3025 4 27.8554 17.3015 5.57876 -0.492343 9.99532 -20.1105 -3026 4 26.7867 16.4634 6.29535 -11.4685 -3.6273 -5.68351 -3027 6 47.2692 11.6326 26.0701 -7.51592 -12.561 -4.95541 -3028 4 47.0451 11.5188 27.0189 12.1951 16.3083 -15.426 -3029 4 47.7234 12.4489 25.7723 -5.45211 -2.19527 19.0308 -3030 6 27.5533 7.05227 7.64253 19.1893 -9.34804 28.5196 -3031 4 26.7486 7.45205 7.94122 -22.9318 8.15137 -1.85106 -3032 4 28.0959 7.04706 8.46187 -1.51515 -0.839126 -23.0353 -3033 6 39.7861 9.0687 11.9758 -15.1444 6.22431 -7.98147 -3034 4 39.495 9.25597 11.0599 4.77492 -2.72739 13.3066 -3035 4 38.9879 9.23938 12.5098 3.46881 -0.389139 -2.20355 -3036 6 18.1894 33.4728 36.1008 -27.5283 -9.1571 7.06889 -3037 4 17.6722 33.9726 35.425 4.94426 -9.47891 13.9641 -3038 4 17.5468 32.9442 36.6812 19.6546 19.0371 -24.2711 -3039 6 37.1945 26.5569 0.720807 -12.4444 8.19753 -2.53971 -3040 4 37.3568 25.6462 0.476597 4.7119 -6.04631 0.679389 -3041 4 36.2336 26.6328 0.585525 8.76389 3.8419 -0.879611 -3042 6 44.2004 19.6233 36.8917 26.7932 -13.3754 0.0595121 -3043 4 45.0387 19.0956 36.766 -19.227 18.7818 5.02367 -3044 4 44.4376 20.5683 36.9644 1.27086 -9.01627 -1.91077 -3045 6 27.7799 6.35317 35.6882 16.2858 -3.70231 1.18314 -3046 4 27.1634 6.96571 35.2926 -9.46908 3.45363 -4.90602 -3047 4 27.3042 5.53742 35.858 -2.00694 0.00942349 2.38052 -3048 6 34.7653 16.4924 20.8795 20.4023 -19.0949 10.3746 -3049 4 35.5516 15.8729 20.9898 -30.5098 25.2475 -4.70775 -3050 4 34.1298 16.2162 21.5757 7.90375 5.70636 -13.0995 -3051 6 39.0303 20.9673 40.4307 -20.4786 -67.2325 12.8224 -3052 4 38.8254 20.089 40.9106 11.5443 40.6977 -30.184 -3053 4 39.2642 21.5386 41.1412 8.11615 27.562 18.514 -3054 6 10.8068 27.9205 1.65866 27.4379 7.91142 -24.506 -3055 4 10.0967 27.7204 2.22826 -30.9372 -12.069 25.0324 -3056 4 10.8782 28.8813 1.73209 2.10338 1.16742 -2.23752 -3057 6 47.025 23.1272 13.2603 -26.8307 -11.5375 0.419605 -3058 4 47.6563 23.6094 12.7175 1.22463 1.60122 -3.88323 -3059 4 46.2701 22.846 12.6737 25.4538 5.98786 18.4886 -3060 6 34.5769 28.3999 10.6617 -26.3731 9.09486 -11.6064 -3061 4 34.5145 27.7223 11.3448 13.7244 -2.44185 1.37306 -3062 4 35.5023 28.5375 10.4336 6.33869 -4.76798 1.2135 -3063 6 3.33738 17.579 14.2816 -4.12164 13.1786 -2.02309 -3064 4 3.51487 16.7052 14.5979 -0.480238 -24.8864 6.17379 -3065 4 3.96197 18.0965 14.8055 -3.35437 6.17503 -1.46632 -3066 6 27.7248 11.5976 7.52038 4.0705 34.1711 4.34085 -3067 4 27.7194 12.5939 7.6487 2.26317 -33.1326 -4.66749 -3068 4 27.2616 11.2314 8.28138 -1.22149 -2.70865 2.4378 -3069 6 41.4317 28.339 9.02961 12.1835 18.6619 -21.5911 -3070 4 40.932 28.9387 9.57928 -8.65956 3.59764 13.3257 -3071 4 41.6711 28.9179 8.26221 -0.754142 -18.9314 12.3863 -3072 6 42.0732 4.78493 8.18399 0.592074 10.501 -23.0953 -3073 4 42.2656 5.73441 7.90258 -4.03181 -32.5079 3.94615 -3074 4 41.9391 4.19656 7.39311 5.50228 24.8072 19.85 -3075 6 28.4553 8.6408 40.3288 -1.1592 2.81238 -0.593175 -3076 4 27.8014 8.47839 41.05 3.29603 2.13238 -25.5829 -3077 4 28.0374 8.68456 39.4248 -2.58083 -3.24862 30.0681 -3078 6 0.723272 18.248 15.2854 4.61761 3.31073 11.0333 -3079 4 1.58056 18.1517 14.8782 17.0637 -0.561901 -5.4503 -3080 4 0.169553 17.7112 14.727 -13.9143 -7.94922 -7.42873 -3081 6 7.11829 16.2161 40.455 0.573222 -5.60735 -16.9123 -3082 4 7.21814 15.2583 40.7035 1.10072 25.2259 14.7352 -3083 4 7.17549 16.8833 41.1741 1.82325 -21.1089 2.38217 -3084 6 41.0856 8.6232 20.9154 1.44565 10.3804 -0.748136 -3085 4 40.3857 8.53297 20.2693 -12.0873 -13.8416 -3.91841 -3086 4 41.3541 9.53003 20.731 8.87844 6.62655 8.68036 -3087 6 31.7065 7.41805 37.5384 1.8504 0.880847 10.656 -3088 4 31.4927 7.12037 36.644 -5.569 -4.06437 0.235955 -3089 4 30.9766 7.14703 38.1182 6.88034 1.43502 -8.9471 -3090 6 40.7175 11.6353 25.4105 -5.83472 20.1078 -6.29096 -3091 4 40.8441 12.5768 25.6218 -9.59803 -8.51017 -7.38463 -3092 4 41.5254 11.2592 25.7328 13.3582 -17.7026 5.353 -3093 6 29.8893 30.1615 6.66958 6.45784 -4.04896 -4.41327 -3094 4 30.5285 30.6751 6.15191 0.92206 -5.81994 -1.29615 -3095 4 30.2313 29.249 6.64761 -0.535397 8.70224 -1.24193 -3096 6 40.83 24.591 5.67679 17.1105 23.9162 -4.99229 -3097 4 41.4401 25.3556 5.89599 -18.0089 -21.1831 -4.73113 -3098 4 40.1352 24.5742 6.32932 -4.29697 2.2625 8.62223 -3099 6 34.3954 9.09122 20.4203 -0.702674 2.95809 7.47625 -3100 4 33.5897 9.50113 20.7506 -0.63314 5.38769 7.97821 -3101 4 34.107 8.76785 19.5728 -0.194313 -9.82044 -16.4611 -3102 6 18.2164 33.5433 26.5438 32.3972 -29.6611 -30.5808 -3103 4 19.1929 33.4142 26.4527 -23.3283 -2.37285 -6.48837 -3104 4 18.1915 34.0681 27.3044 -13.0981 29.1765 42.7321 -3105 6 28.9207 17.4075 26.7926 -1.66434 -4.11711 9.90999 -3106 4 28.2497 17.0259 26.21 0.151798 0.605301 -3.15085 -3107 4 28.4243 17.7127 27.5796 8.50802 -3.38176 -8.48604 -3108 6 50.4389 35.5612 18.195 -0.220837 -24.3132 -9.08897 -3109 4 50.4331 35.2145 17.2813 -0.853004 14.3463 8.17747 -3110 4 50.3692 34.7248 18.6968 -4.07606 17.1918 3.62275 -3111 6 2.99582 21.5586 31.4575 0.708202 -18.646 -28.6731 -3112 4 3.24926 22.2892 30.8424 -5.67023 -11.8068 12.1364 -3113 4 2.8516 20.7624 30.8616 4.12476 24.3831 20.6408 -3114 6 36.1857 18.7483 8.60511 9.96184 26.1081 -2.68835 -3115 4 36.1356 17.8778 8.93402 3.95956 -36.7917 21.724 -3116 4 35.6171 18.7388 7.85438 -14.2398 9.24248 -24.4438 -3117 6 20.2742 6.47995 33.7286 -0.427153 4.78104 -4.08195 -3118 4 19.8935 6.35632 34.6244 -2.14212 -11.6635 -12.611 -3119 4 20.0876 5.70362 33.1559 -1.45185 1.76636 16.8362 -3120 6 13.9952 30.5211 6.65468 -0.834568 0.374695 7.89925 -3121 4 14.6781 31.0539 7.1149 -10.4447 -7.07426 -7.17019 -3122 4 13.1432 30.7212 7.07951 7.79461 1.02333 -2.73826 -3123 6 36.2732 16.4484 35.7639 18.345 14.0335 0.961522 -3124 4 37.2268 16.2475 35.9495 -24.6333 8.21497 -3.5549 -3125 4 36.1837 17.4253 35.5797 7.74798 -29.1845 4.36862 -3126 6 45.8208 37.6575 9.69399 14.3507 -31.8621 -27.6249 -3127 4 45.4608 38.3019 10.268 -8.06385 16.394 26.7739 -3128 4 46.3975 37.0305 10.1733 -1.81999 10.6315 0.898341 -3129 6 47.4165 17.984 27.6369 4.10759 -46.3966 -5.45297 -3130 4 47.5682 17.4629 26.7823 -7.01073 17.4072 30.8444 -3131 4 47.4562 17.3293 28.4007 0.542452 20.9274 -25.5144 -3132 6 25.9608 18.2932 0.952258 -4.39486 21.5955 18.9376 -3133 4 26.1989 18.9101 1.66086 12.5057 -8.35286 -7.15646 -3134 4 25.0082 18.3237 1.04468 -12.1408 -13.2893 -13.6751 -3135 6 27.3648 22.4066 4.28268 2.26175 -24.9034 0.419816 -3136 4 27.3706 23.3409 4.46802 1.80952 16.8807 -5.51915 -3137 4 27.3027 22.2785 3.32806 -2.77408 5.10873 4.5687 -3138 6 3.39125 3.84856 27.607 3.69966 -10.1033 0.490887 -3139 4 4.0137 4.55908 27.5406 6.78149 24.6072 0.911673 -3140 4 3.97847 3.09168 27.5281 -8.4044 -12.3732 0.103181 -3141 6 45.3633 27.6554 28.8452 2.12727 -1.25659 10.7713 -3142 4 44.5282 27.2015 28.6866 -4.83999 -4.58212 3.48715 -3143 4 45.3811 28.2979 28.14 4.63148 6.41932 -6.37453 -3144 6 28.4005 32.3772 16.2203 23.7034 -3.75626 0.763822 -3145 4 29.2297 32.2225 15.6968 -18.0553 4.16843 14.9752 -3146 4 28.6795 32.6874 17.1033 -0.325788 -1.29005 -11.6373 -3147 6 9.90477 33.835 13.0292 3.70295 -3.7397 30.9684 -3148 4 9.58558 33.3049 13.7992 6.56164 12.5415 -12.6178 -3149 4 9.32425 33.6546 12.2978 -12.2649 -3.83445 -16.8068 -3150 6 38.3301 26.6316 14.917 8.16845 -9.374 -1.40965 -3151 4 38.7482 25.7736 15.154 -10.3234 14.7528 -2.05039 -3152 4 37.3847 26.6122 15.1206 3.66029 -5.29 2.35016 -3153 6 31.3553 16.3729 4.24558 -11.5598 -13.3523 13.2112 -3154 4 30.5395 15.8971 4.54084 13.4071 7.11555 -7.19651 -3155 4 31.205 16.607 3.32285 -2.62497 2.93757 -4.30077 -3156 6 6.17611 3.41063 6.5613 17.7272 3.64487 37.5473 -3157 4 6.46982 3.08663 7.46094 -9.0795 17.2981 -27.883 -3158 4 6.02642 2.6045 6.08389 -2.81663 -13.5692 -12.3872 -3159 6 42.5919 12.9938 5.62253 0.302259 -11.3067 -0.460125 -3160 4 42.3001 13.8766 5.84478 4.87778 6.39543 1.2284 -3161 4 43.5084 12.9049 5.92305 -2.35353 0.46184 -1.33783 -3162 6 41.0467 31.3953 33.7949 3.79599 37.3117 5.16998 -3163 4 40.7289 31.3961 34.7173 5.05156 -5.30154 -15.2916 -3164 4 41.2174 32.3636 33.5809 -4.47671 -37.1445 4.47908 -3165 6 52.8595 12.0576 26.2617 4.7779 -12.5882 -49.4794 -3166 4 52.3971 12.713 26.7564 -13.8804 18.303 15.9364 -3167 4 52.6839 12.2865 25.2977 8.87889 -9.64762 29.5111 -3168 6 39.2197 4.29237 29.0569 11.235 6.95972 3.08537 -3169 4 38.4782 4.84799 29.3396 4.36118 -6.50894 -4.0878 -3170 4 39.9967 4.59393 29.5615 -4.77927 -7.36273 -4.89832 -3171 6 3.64414 27.0065 11.2815 -12.9441 10.9516 -6.43872 -3172 4 4.59106 26.8908 11.2849 14.3058 -9.72403 4.26042 -3173 4 3.53535 27.8319 10.7781 -8.82957 -2.80904 -0.131447 -3174 6 41.5421 29.6442 25.2671 -5.6293 3.19366 2.66863 -3175 4 41.8684 29.6903 24.3723 12.1179 -3.11764 -10.4285 -3176 4 40.7194 30.1326 25.2057 -6.30215 2.63585 1.74894 -3177 6 50.468 27.487 30.6705 -3.05594 -10.4468 2.57161 -3178 4 50.076 27.1594 31.5009 0.806547 4.01213 -5.24181 -3179 4 49.8217 28.0451 30.2184 -2.62753 1.96724 1.87939 -3180 6 32.7902 33.6258 41.7496 -4.87138 -4.97834 -25.0012 -3181 4 33.1641 32.7497 41.8541 3.47816 -11.5824 1.65798 -3182 4 32.8969 34.0586 0.665858 3.16614 12.7166 21.4132 -3183 6 5.9796 9.64598 7.93234 5.57207 13.1841 -10.7861 -3184 4 5.80592 9.95912 8.82583 -0.986272 -0.521215 4.5825 -3185 4 6.43021 10.3852 7.47125 -1.05258 -10.6241 3.31462 -3186 6 52.774 25.3768 27.6816 12.7732 -3.18466 28.0173 -3187 4 52.93 26.2779 28.0237 -8.60677 -10.695 -13.1321 -3188 4 53.2011 24.8527 28.4031 -8.37753 -2.27765 -26.5487 -3189 6 18.6947 23.2095 14.4724 -28.0966 8.43578 15.8218 -3190 4 18.5587 24.1605 14.7523 20.6562 -24.296 -13.1918 -3191 4 19.5669 23.0215 14.1303 11.4888 10.4676 -1.8787 -3192 6 31.2862 9.0706 13.0896 18.8649 -43.5027 -8.26415 -3193 4 31.2854 8.18164 13.5153 -0.98006 14.2242 -7.24428 -3194 4 30.8139 9.64196 13.6614 -21.2648 23.3567 24.384 -3195 6 52.8349 16.8368 29.9626 -1.04236 -5.83632 -3.7224 -3196 4 53.1314 16.3317 29.1809 4.11254 10.2245 6.81583 -3197 4 53.5336 17.4658 30.2088 5.59995 -2.32318 -6.64835 -3198 6 13.48 30.6403 11.9185 -26.7 12.8254 18.6299 -3199 4 12.8874 31.2649 12.4086 6.11749 -21.3055 -11.69 -3200 4 14.2712 31.1662 11.9231 18.3999 3.72963 -5.07782 -3201 6 24.4118 24.6653 11.1776 -11.0488 -38.9105 0.0232616 -3202 4 25.2327 25.0345 11.4834 15.6111 8.28781 8.86477 -3203 4 24.5324 23.6736 11.237 -9.01076 27.817 -2.51724 -3204 6 11.1207 26.7925 5.93063 -6.41259 2.09364 -8.23675 -3205 4 11.5241 26.98 6.79711 -3.12879 8.72791 -6.17468 -3206 4 10.8719 27.6544 5.50988 6.7003 -18.2386 15.7162 -3207 6 12.0069 32.3194 4.56559 -6.93674 1.89769 -53.2748 -3208 4 11.7104 31.8608 3.68045 16.1117 25.2499 46.2442 -3209 4 12.3686 33.2222 4.3326 -9.20365 -26.1492 2.14142 -3210 6 6.43611 5.48582 30.4705 10.9412 7.27018 -5.81208 -3211 4 6.8324 6.31983 30.1884 15.302 -0.761667 0.276275 -3212 4 5.5204 5.70213 30.4126 -22.6187 -2.98333 3.5448 -3213 6 38.1723 39.6045 29.3805 -11.1368 -0.968084 -7.99101 -3214 4 37.5332 40.3179 29.1036 12.1085 -24.1545 -0.917311 -3215 4 37.9804 38.7063 28.9788 -2.28765 36.4506 5.30967 -3216 6 52.5924 19.3736 5.41149 4.12965 0.0949992 -5.17576 -3217 4 52.3027 20.2712 5.07121 22.7239 -28.0308 -2.84369 -3218 4 53.4989 19.0543 5.10701 -28.7609 25.7225 2.66162 -3219 6 18.3561 9.81057 21.0683 -18.476 -24.6523 15.6829 -3220 4 17.6378 9.45854 20.4828 20.1245 14.4878 5.80252 -3221 4 19.033 10.2869 20.5982 6.82627 10.6552 -20.9713 -3222 6 14.5094 41.1238 15.0395 5.73538 -4.06503 -13.1796 -3223 4 15.2839 41.068 15.6075 4.55031 0.900939 7.74817 -3224 4 13.875 41.6599 15.5263 0.0235554 2.15182 4.98288 -3225 6 36.0027 23.903 26.7597 7.48895 21.6763 -35.676 -3226 4 35.8975 23.6043 27.6465 2.36908 -17.7227 17.2904 -3227 4 36.3267 23.2124 26.1374 -7.97178 4.49324 27.7844 -3228 6 35.6359 10.4157 26.2529 -13.2839 -25.1837 23.1485 -3229 4 35.969 10.5098 25.3716 5.3977 0.436992 -21.1808 -3230 4 35.4229 9.45302 26.3798 5.18698 20.1527 -7.56493 -3231 6 45.3037 24.2791 20.2723 9.06075 11.2998 -13.4968 -3232 4 45.4523 24.978 19.6109 10.2075 -1.49386 4.95329 -3233 4 44.5125 23.8555 19.9662 -13.3892 -9.58217 -2.04663 -3234 6 15.8107 39.0453 24.2393 9.7405 19.086 8.48056 -3235 4 15.3407 39.8143 24.6455 3.07287 -17.6695 -6.90152 -3236 4 16.7434 39.3626 24.1878 -22.1708 -8.11019 0.25747 -3237 6 4.61074 25.9041 16.8066 4.47487 12.325 4.32837 -3238 4 5.33363 26.3313 17.2996 -1.16871 -8.95741 -3.63592 -3239 4 3.89121 26.5439 16.91 5.27726 -3.71411 -3.28281 -3240 6 33.4791 9.99232 32.5716 -36.5508 -4.76722 -31.2046 -3241 4 34.3147 10.2419 32.89 39.2476 10.968 21.6954 -3242 4 33.0188 9.57531 33.3002 0.324125 -5.12222 10.2577 -3243 6 22.9388 37.5185 1.51191 -4.27166 -24.2064 8.31852 -3244 4 23.0334 38.2273 2.154 1.20614 3.86272 6.71724 -3245 4 22.69 36.6978 2.02191 6.96614 23.4315 -10.5782 -3246 6 39.1324 20.5485 25.4772 25.265 -11.778 19.9951 -3247 4 39.2103 21.4279 25.1215 -1.526 12.0473 -3.88318 -3248 4 39.8813 20.4818 26.1301 -17.748 -0.0581828 -14.4699 -3249 6 25.0622 25.0762 37.6014 21.4558 5.76047 -13.7935 -3250 4 26.0349 25.2337 37.6294 -19.4467 -8.38624 -4.14531 -3251 4 24.8891 24.8197 38.5048 -7.65564 -1.94532 12.2316 -3252 6 12.209 35.7591 11.4203 -9.12536 1.25056 -5.53999 -3253 4 11.4995 36.2015 10.8899 19.2305 -11.6187 8.3526 -3254 4 12.8486 35.4161 10.7797 -5.71729 7.89629 -2.43108 -3255 6 42.046 15.7235 20.1276 29.9467 5.46844 -26.2367 -3256 4 42.5818 15.5034 19.3148 -14.0105 1.75231 17.5608 -3257 4 42.3615 16.6209 20.337 -4.0808 -2.27778 2.90042 -3258 6 53.2021 25.4307 39.5282 4.69599 -13.2561 7.07883 -3259 4 53.78 25.8541 38.905 5.49131 5.5629 -6.42231 -3260 4 52.4802 26.028 39.6966 -10.1139 9.50655 0.821399 -3261 6 53.7967 21.778 1.29815 15.5744 -8.20383 1.43914 -3262 4 54.6378 21.4326 0.944441 -3.84265 -1.46767 8.18122 -3263 4 53.3536 22.1543 0.542634 -13.037 9.31425 -11.6048 -3264 6 1.93111 22.4438 20.1768 4.00387 4.12813 31.1185 -3265 4 1.5939 23.2361 20.6593 2.49828 -13.4199 -15.2591 -3266 4 2.41139 21.9607 20.8911 -6.34657 6.89732 -14.8434 -3267 6 41.1871 16.1847 11.4932 0.836017 42.0531 1.99799 -3268 4 40.9413 15.3195 11.802 -9.8633 -17.6073 7.87469 -3269 4 40.5377 16.8617 11.8588 16.4331 -27.7799 -8.96912 -3270 6 17.194 38.6096 9.61825 4.75854 -2.20459 -16.4638 -3271 4 17.8324 38.6167 10.328 10.0816 -0.610832 12.429 -3272 4 16.3385 38.6013 10.0398 -14.9506 0.593169 11.9887 -3273 6 33.2005 12.9606 38.531 8.50507 10.8774 -15.8661 -3274 4 33.6532 13.8203 38.39 -7.98235 -13.7359 5.26797 -3275 4 33.1331 12.8007 39.479 5.11874 5.24255 -4.23095 -3276 6 24.7171 21.675 39.9778 2.8762 -23.2501 -10.2076 -3277 4 24.5558 21.597 39.0096 0.45736 0.189324 11.8412 -3278 4 25.3262 20.9394 40.2143 -5.83632 9.86919 -3.30671 -3279 6 13.5803 15.5602 27.3532 26.1047 30.3564 11.1382 -3280 4 13.1676 16.145 28.014 -3.26959 -8.19558 -5.9347 -3281 4 12.973 14.8589 27.1951 -20.4184 -17.1677 1.43072 -3282 6 24.68 18.7128 9.26691 14.3839 36.3501 26.0009 -3283 4 25.3598 19.2552 8.82532 -5.31062 -15.6251 -9.27674 -3284 4 24.5166 19.2286 10.0937 -4.12977 -20.8661 -14.1648 -3285 6 10.971 8.2031 0.0820528 -5.05885 27.6393 52.7366 -3286 4 10.426 8.82187 0.676738 20.6953 -23.692 -21.2054 -3287 4 11.8511 8.19112 0.51746 -10.8092 -0.715691 -8.01276 -3288 6 15.7168 31.9426 31.3882 -16.0589 -14.8784 11.374 -3289 4 14.8784 32.0139 30.9212 -5.19427 4.39929 -5.1125 -3290 4 16.2361 32.7208 31.1626 4.51908 -4.85975 -1.07492 -3291 6 20.3853 39.1678 21.6201 3.96912 1.70678 -2.15463 -3292 4 19.8408 38.4031 21.9136 18.3946 15.2484 5.21077 -3293 4 21.1259 39.3411 22.2478 -18.5683 -14.4588 -3.61544 -3294 6 38.8575 19.5345 7.60357 -3.22682 7.2187 -10.7103 -3295 4 37.9955 19.1157 7.58645 -3.56529 1.50397 -1.646 -3296 4 39.2183 19.2349 8.43232 7.58358 -7.76078 7.45775 -3297 6 41.3566 29.7161 21.1634 -18.4754 -13.1658 17.2704 -3298 4 41.7904 29.7702 20.3348 3.95998 3.00501 -30.3792 -3299 4 42.0386 30.0045 21.7486 9.4821 7.67994 22.7786 -3300 6 50.7055 33.8359 22.0677 10.0235 -14.5617 12.8511 -3301 4 51.0634 32.983 22.4061 -4.7136 19.0099 -8.42991 -3302 4 50.4062 33.6539 21.1646 0.0172424 0.211956 1.78818 -3303 6 18.1576 11.1602 14.3564 -14.1594 -3.53412 4.86119 -3304 4 18.0624 11.3441 15.3149 3.69196 -2.83217 -14.991 -3305 4 19.1071 11.0831 14.1997 2.21718 -0.861887 0.62752 -3306 6 48.509 14.2737 15.2536 -33.8512 -15.7039 -13.3543 -3307 4 49.4102 14.4821 15.4142 31.3042 4.03673 3.1002 -3308 4 48.4635 13.5769 14.5611 0.497508 10.2707 10.4073 -3309 6 32.9892 15.7452 8.24788 15.5762 1.59093 3.47394 -3310 4 33.8184 15.532 7.78513 -5.99942 0.288096 4.45585 -3311 4 33.1922 15.7362 9.20789 -3.05234 -0.622843 -13.6288 -3312 6 42.9176 4.85532 18.7629 14.1748 1.41964 3.40057 -3313 4 42.9882 5.82921 18.9229 4.77982 -22.1758 1.39114 -3314 4 43.8043 4.45344 18.9624 -18.3785 17.0247 -7.93082 -3315 6 10.5031 23.7237 33.4382 -0.874073 19.9298 2.74355 -3316 4 10.5548 24.717 33.3795 7.7257 -28.8706 -7.54496 -3317 4 11.1379 23.281 32.8547 0.735263 11.3428 1.89897 -3318 6 1.13216 20.0583 11.2836 18.374 17.5884 12.1148 -3319 4 0.491024 19.3349 11.1994 -2.17247 3.20995 10.4498 -3320 4 1.13554 20.5377 12.169 -13.4236 -25.5013 -29.3002 -3321 6 1.52072 39.5358 14.3069 -1.86369 -19.4721 11.7014 -3322 4 0.846705 40.1803 14.5938 4.14733 -5.95668 -5.60613 -3323 4 1.29368 38.6598 14.724 6.32152 28.9753 -9.07681 -3324 6 8.31775 21.6111 14.1387 -15.017 -6.93379 31.3726 -3325 4 8.13664 21.1659 15.0266 4.22851 15.111 -30.7591 -3326 4 7.52757 21.5034 13.5919 -1.9589 1.09648 1.01763 -3327 6 7.16491 13.3069 38.2405 -3.91014 1.61314 -29.5843 -3328 4 6.63698 13.0539 37.4502 4.01765 -4.94514 23.7112 -3329 4 7.51249 14.1719 37.966 2.17516 -8.38294 10.659 -3330 6 46.6268 1.62726 18.6981 -5.20766 -2.9114 16.5849 -3331 4 47.5711 1.68468 18.9367 -9.38594 -0.162468 5.90612 -3332 4 46.1191 1.48652 19.5414 20.1897 3.23395 -16.531 -3333 6 4.07867 8.38347 14.797 30.0262 18.9917 2.43531 -3334 4 3.34187 8.3175 15.3794 -25.1937 -7.21885 10.0707 -3335 4 3.92422 7.81173 14.052 -7.87119 -13.0009 -15.9092 -3336 6 47.5843 36.535 17.848 27.4213 12.0237 5.93301 -3337 4 47.2301 35.69 17.6416 -25.9655 -28.1947 -7.00186 -3338 4 48.5203 36.321 17.8356 11.6458 7.4707 2.49139 -3339 6 48.7172 32.6081 3.62434 16.9155 19.6851 -27.3563 -3340 4 49.4676 32.1613 3.18145 -8.8052 -0.0369675 17.0972 -3341 4 48.3534 32.1141 4.33579 -5.12692 -24.8974 22.5299 -3342 6 26.8624 34.4063 15.194 -5.61502 8.38998 -0.355377 -3343 4 27.128 33.6719 15.7603 3.91671 -4.37186 -8.54489 -3344 4 27.3784 34.3384 14.3661 -3.09932 -5.4603 13.6569 -3345 6 9.98983 27.3411 13.3236 -5.30345 -60.6937 -19.0037 -3346 4 9.94192 28.2179 13.0053 -1.51785 37.2293 -13.4128 -3347 4 9.87191 26.7487 12.5139 4.66007 24.2176 27.9858 -3348 6 2.39898 26.8872 37.357 1.59401 -7.29113 19.9813 -3349 4 2.39832 26.7504 38.3162 -5.28205 -0.510768 -0.23331 -3350 4 3.33711 26.9514 37.1904 14.8183 3.44774 -11.9786 -3351 6 33.3368 17.2756 36.8005 -23.2882 7.84328 1.94786 -3352 4 32.371 17.4043 36.8526 5.24602 0.476467 11.7287 -3353 4 33.4423 17.1515 35.8622 12.5187 -3.29866 -15.2334 -3354 6 10.6624 18.8035 9.30575 -3.98781 15.2275 -14.7508 -3355 4 10.7339 18.764 8.32616 -2.59554 -5.92059 15.2764 -3356 4 10.8972 19.732 9.49452 -1.55193 -6.4517 3.37647 -3357 6 8.57833 27.4047 3.14019 -5.09403 -6.13324 -2.85576 -3358 4 8.57126 27.6547 4.08504 -2.7611 -8.03155 -6.83353 -3359 4 8.4622 26.4231 3.09919 3.19624 23.0742 12.9307 -3360 6 40.6073 33.9264 14.3399 -6.85038 20.2562 -23.9123 -3361 4 40.863 33.245 14.948 0.807967 -8.16399 15.1571 -3362 4 40.0779 34.5716 14.8204 -0.495244 -4.69725 4.10141 -3363 6 53.9925 16.7992 13.6308 6.31935 -7.9338 28.1888 -3364 4 54.0997 17.1551 12.7528 -11.031 14.1585 -18.9596 -3365 4 53.1709 17.0486 14.0912 -3.14305 7.59696 -13.573 -3366 6 39.1497 38.4912 7.40608 -39.1223 4.05884 30.5073 -3367 4 38.8859 38.5922 6.48797 -2.00378 4.08479 -3.77896 -3368 4 38.3062 38.5986 7.97667 35.5804 -2.74434 -28.8566 -3369 6 42.2129 33.6808 29.0138 -24.1371 3.42921 -11.8129 -3370 4 42.1057 34.6378 28.7577 -2.98627 -25.8941 0.854821 -3371 4 41.3475 33.1819 28.8496 28.8118 27.0492 8.45917 -3372 6 2.85866 0.0629173 20.1315 -20.2536 1.52979 -19.4947 -3373 4 2.75203 0.421025 19.2221 8.85994 -2.20895 9.93397 -3374 4 1.96017 41.6124 20.299 15.6791 2.4666 6.01858 -3375 6 24.986 26.9373 24.4454 -5.13687 18.0728 7.96565 -3376 4 25.2851 26.0172 24.3926 4.88984 -3.86206 4.04103 -3377 4 25.2923 27.4081 25.2509 0.579281 -17.4573 -11.648 -3378 6 13.6179 33.9875 7.01366 -9.87556 12.4155 -39.0476 -3379 4 14.4287 33.6264 6.65472 5.99816 -4.92128 6.68342 -3380 4 13.2096 34.3429 6.17379 4.4552 -5.00021 31.0775 -3381 6 17.6494 31.8378 3.38868 3.47258 32.8259 -24.0658 -3382 4 17.3179 32.0585 2.49435 6.00696 -1.44586 18.975 -3383 4 17.3532 30.9566 3.5196 -11.0767 -31.773 11.9025 -3384 6 31.1111 29.8483 35.9167 13.6376 7.61418 -14.6842 -3385 4 30.4141 29.611 36.5018 -19.519 -6.65958 16.6428 -3386 4 31.8988 29.4329 36.2727 4.98993 0.410401 2.8928 -3387 6 31.4643 1.69164 1.93808 20.5111 47.6543 28.2436 -3388 4 30.8038 1.05919 1.86135 -35.916 -50.7273 -13.0106 -3389 4 30.9957 2.32106 2.5233 13.9145 -2.66096 -10.7861 -3390 6 13.7147 9.36591 12.3063 -10.8769 -31.3803 3.40225 -3391 4 14.006 10.2311 12.0687 5.19854 25.7457 4.3425 -3392 4 13.2135 9.34561 13.1466 7.78847 9.513 -6.56361 -3393 6 15.2882 15.1512 12.1315 -28.7349 -8.10496 1.75886 -3394 4 14.285 15.1274 12.2085 32.3197 -4.02875 -3.81405 -3395 4 15.5527 14.5676 11.4001 -6.69875 1.91641 1.76342 -3396 6 44.9132 30.4441 13.088 -39.1187 -0.31911 18.6923 -3397 4 45.3561 30.6438 13.8967 -2.95974 2.37903 28.1101 -3398 4 45.6316 30.4633 12.5179 38.3165 -3.24606 -51.9295 -3399 6 35.1465 37.623 24.8576 -14.1582 -15.7359 28.7413 -3400 4 34.5779 38.3725 25.1706 10.6028 -16.3472 -5.82963 -3401 4 34.9593 36.856 25.4995 5.71155 29.9045 -22.7235 -3402 6 43.8948 19.2936 12.9987 -2.30513 -18.2146 13.0469 -3403 4 43.787 18.3102 12.9069 2.76315 21.1578 4.09431 -3404 4 44.375 19.4187 13.8444 -6.58761 -4.34429 -6.9628 -3405 6 14.1971 27.3925 16.8971 2.69526 11.3314 -20.1154 -3406 4 13.4533 26.7979 16.9981 -2.42546 -10.6182 5.16389 -3407 4 14.0783 27.734 15.9851 5.1255 -3.8968 13.4589 -3408 6 5.08574 37.4729 15.7377 1.34169 3.72011 38.8669 -3409 4 5.88395 37.4897 16.2981 -4.65405 2.63162 7.63907 -3410 4 5.46406 37.2335 14.9215 11.9791 -13.9554 -41.5179 -3411 6 35.4862 36.9766 33.2333 -36.83 -5.70901 2.9599 -3412 4 36.4114 37.1444 33.1615 28.5824 10.2327 4.96708 -3413 4 35.1164 37.4942 33.9725 5.15458 -1.79752 -2.84758 -3414 6 6.636 31.7097 32.9848 -22.7133 -7.33235 -24.9389 -3415 4 7.22761 30.9741 32.8206 4.14198 -5.34147 5.16294 -3416 4 6.9999 32.2337 33.6789 14.5784 9.31919 13.8511 -3417 6 31.283 20.2175 25.4647 -9.91499 -1.61286 9.73388 -3418 4 30.5344 20.24 26.1037 18.6204 0.149313 -5.83605 -3419 4 30.8734 20.4846 24.6365 -0.167457 4.09649 -2.99843 -3420 6 54.9487 26.0868 7.35258 -28.6285 -0.216784 1.76255 -3421 4 54.2955 26.5615 6.794 6.74078 -5.97369 7.99882 -3422 4 54.4034 25.6757 8.0611 9.89476 6.61779 -10.5703 -3423 6 17.8651 35.1614 24.3791 -20.7499 -4.98646 -29.5673 -3424 4 18.0576 34.6235 25.1649 -8.37985 -1.7243 -11.1178 -3425 4 17.2007 34.681 23.779 26.831 10.1018 28.2803 -3426 6 49.1285 3.31358 19.7417 -8.45795 -3.91869 -17.1851 -3427 4 48.8119 4.11203 20.1653 -3.29153 9.9905 4.05996 -3428 4 49.7807 2.96094 20.3466 4.32541 -4.85853 3.16639 -3429 6 30.2844 35.6035 13.4934 7.2001 -0.317469 -2.452 -3430 4 29.4623 35.659 12.9857 1.71884 -1.71824 2.45729 -3431 4 30.0585 35.4328 14.4204 -4.00669 1.3983 -5.34585 -3432 6 43.3887 25.8808 41.6785 -22.9069 -12.3923 -2.55701 -3433 4 43.9997 25.6768 40.9817 12.0928 0.211006 -14.0269 -3434 4 43.8339 26.4255 0.397834 14.8568 14.8319 19.2759 -3435 6 21.0884 23.1529 6.38678 -1.35916 1.28851 13.8592 -3436 4 21.4 23.8645 6.98768 -5.78702 -12.5756 -9.70729 -3437 4 21.3246 23.4545 5.51028 2.40121 5.3387 -13.5131 -3438 6 54.6143 21.1989 19.0895 1.0726 18.3039 13.0104 -3439 4 0.43531 21.5582 19.5367 -15.0683 -8.68203 -12.1911 -3440 4 53.867 21.7044 19.4937 16.3508 -9.47613 -7.9193 -3441 6 13.877 38.9443 18.7624 -3.57764 -10.5141 -5.7706 -3442 4 13.4493 38.4672 19.4981 1.6116 7.10734 -3.21136 -3443 4 14.0821 39.8514 19.0249 -5.40993 2.00969 6.25434 -3444 6 39.1872 2.73234 39.6824 0.14108 0.727177 -8.14712 -3445 4 38.529 2.27328 40.2354 4.03816 -1.16808 -5.22543 -3446 4 39.0548 2.41866 38.7627 -6.48078 -0.982324 12.2661 -3447 6 43.2185 33.8148 8.84061 -19.4182 46.8926 -2.36482 -3448 4 43.1772 32.9719 9.24022 -1.50187 -35.3898 17.2737 -3449 4 42.5163 34.3616 9.29053 19.0727 -15.0644 -10.6104 -3450 6 23.089 16.6827 12.1027 15.7208 -3.2574 -7.89972 -3451 4 23.4385 16.1911 11.3228 -11.6069 8.24456 13.4993 -3452 4 22.136 16.8018 11.9813 0.424679 -1.38664 -3.29845 -3453 6 40.7855 26.1389 36.3196 -19.9126 19.309 9.87347 -3454 4 40.0986 26.8534 36.2514 19.4153 -21.5003 1.38126 -3455 4 41.1517 26.0031 35.4437 4.25962 0.995192 -8.54639 -3456 6 15.1503 11.6717 19.2973 0.724699 -1.19191 17.6918 -3457 4 15.5299 12.2877 18.6792 5.27756 8.7759 -18.41 -3458 4 15.4868 12.0294 20.1269 -4.65024 -4.08223 3.58338 -3459 6 9.86165 29.8154 31.387 -8.94942 -10.7424 5.06077 -3460 4 10.5846 30.1184 31.9716 0.245343 7.83947 -17.0155 -3461 4 9.856 30.1645 30.4637 12.8302 0.479173 21.4055 -3462 6 2.12473 30.035 25.2763 1.78753 8.3758 2.85176 -3463 4 2.08519 29.2167 25.7943 1.54705 3.16986 -12.4779 -3464 4 2.12365 29.8679 24.3136 0.147535 -6.31004 19.3474 -3465 6 49.0081 10.6471 7.05663 3.22839 15.7191 0.010386 -3466 4 49.8069 10.5015 7.59507 -11.7369 -5.9273 -2.35907 -3467 4 48.4474 9.86293 7.09337 3.15572 -10.0552 5.75386 -3468 6 38.6524 34.4248 32.4903 14.0617 12.8107 -4.97275 -3469 4 38.3124 35.2999 32.7524 2.4491 -7.54743 -1.61947 -3470 4 38.3152 33.7696 33.1015 -5.90625 -1.07654 6.02858 -3471 6 24.2925 24.7077 4.76791 -9.60212 12.423 13.627 -3472 4 24.6592 23.9059 5.14091 6.4374 -12.2494 -4.05598 -3473 4 24.0877 25.2629 5.55261 2.76703 -5.61196 -18.2913 -3474 6 44.0394 23.5955 33.7722 -22.1761 -10.7316 25.8053 -3475 4 43.54 23.0408 33.1405 14.8275 10.6039 0.934173 -3476 4 44.7909 24.0173 33.3845 18.136 8.68259 -21.6513 -3477 6 45.1404 31.9557 26.6336 7.63501 -16.8517 -19.5705 -3478 4 44.7419 32.078 27.4825 -5.98757 6.26965 19.5048 -3479 4 44.9572 31.0195 26.4087 0.928196 13.8489 4.22851 -3480 6 52.067 6.35346 22.8527 -23.4258 -19.9992 -0.226773 -3481 4 51.4359 5.65775 23.1792 22.6487 15.1416 -4.78776 -3482 4 51.473 7.11391 22.7826 5.97124 1.02094 -2.8274 -3483 6 5.11659 17.7141 30.4608 -43.6072 -14.7819 8.36724 -3484 4 5.56343 17.5578 29.6371 20.9412 3.52217 -11.7922 -3485 4 5.63141 18.2128 31.0754 22.7819 13.5036 5.79607 -3486 6 48.537 17.0137 6.52887 28.2349 12.1042 -25.3981 -3487 4 48.2628 16.1023 6.56372 -5.81913 -12.4107 2.5618 -3488 4 49.2494 17.0592 5.82246 -25.6562 2.24824 21.9849 -3489 6 13.808 31.3142 23.4689 -3.64011 -9.68131 26.3432 -3490 4 14.1349 31.2178 24.3617 -12.0329 4.75192 12.2102 -3491 4 14.6149 31.173 23.0226 30.8248 -5.26015 -34.1434 -3492 6 28.4946 33.4369 26.0285 16.4638 25.2333 -6.25798 -3493 4 28.7216 32.7387 25.4298 8.48672 -9.67688 -13.795 -3494 4 27.7897 33.0868 26.5316 -24.4903 -9.494 23.2581 -3495 6 9.0435 22.9594 11.008 21.162 0.605596 1.29652 -3496 4 9.33306 22.7779 10.1087 -4.82127 0.713158 -4.26872 -3497 4 9.8456 22.7632 11.5172 -9.5186 2.48902 2.0044 -3498 6 40.5545 4.06728 26.5809 44.6249 -53.7912 6.90123 -3499 4 40.0988 4.06982 27.4038 -17.0162 4.47424 24.8249 -3500 4 40.1579 4.71783 26.0744 -31.5116 46.4114 -32.7723 -3501 6 17.0554 37.9737 20.9489 23.2001 5.84937 -15.1211 -3502 4 17.8184 37.6206 21.4529 -18.1961 -0.773306 2.14347 -3503 4 16.241 37.9215 21.4323 -8.54619 -6.77157 16.0583 -3504 6 31.9589 6.36634 14.2007 -32.7312 -5.18635 1.31695 -3505 4 31.6173 5.45206 14.3159 2.63352 8.72785 -2.4018 -3506 4 32.9006 6.25378 14.1536 18.2531 -4.45925 -0.605861 -3507 6 29.3682 34.9487 39.6588 1.61784 2.82525 -17.5597 -3508 4 29.3689 34.7576 40.5935 -6.77547 -0.101859 12.4897 -3509 4 28.4273 35.0463 39.4168 8.43037 -3.37269 4.33216 -3510 6 22.5699 2.93494 32.1141 -1.63629 -8.86743 4.25418 -3511 4 23.0898 3.67063 31.7669 1.49018 1.71101 -1.29845 -3512 4 22.818 2.15292 31.5827 -1.92581 11.5593 5.09528 -3513 6 51.7444 19.0899 24.8018 18.5566 14.3159 27.8709 -3514 4 52.1262 19.3991 25.6728 -16.855 -8.06891 -29.5747 -3515 4 52.1578 19.634 24.1129 -3.61196 1.33098 2.20453 -3516 6 32.1137 13.664 24.2226 6.2567 1.72658 -37.8727 -3517 4 32.2307 13.7857 25.1378 6.97488 6.10606 45.7276 -3518 4 31.1794 13.5551 24.0935 -22.8325 -3.39176 -1.92521 -3519 6 9.48788 30.1788 28.8037 -7.90151 -0.480281 -10.0021 -3520 4 9.04214 29.3907 28.4657 0.296662 -4.58444 4.12418 -3521 4 9.71381 30.648 27.9899 1.85323 2.91474 4.33114 -3522 6 31.3027 3.12343 24.087 3.70677 4.08208 -3.18372 -3523 4 30.8363 3.94541 23.9161 -7.21645 -1.79011 2.75115 -3524 4 32.1629 3.26377 23.6687 3.35255 -5.74571 3.4439 -3525 6 2.14326 19.8385 36.4613 43.5578 -10.0216 -16.9659 -3526 4 3.05142 19.7594 36.0352 -31.8637 8.98539 19.2185 -3527 4 1.69253 19.0555 36.1346 -14.6763 0.545221 1.96285 -3528 6 36.957 16.7591 14.0918 2.96563 -13.2358 -6.51153 -3529 4 37.0513 17.1687 14.9682 1.23982 -3.45998 -2.6752 -3530 4 37.3406 15.8552 14.1067 -4.20166 12.9403 2.86695 -3531 6 1.82327 11.1921 6.0808 -0.275886 9.47834 -4.04825 -3532 4 1.66503 10.3513 6.51275 0.636708 -7.94921 -0.277572 -3533 4 1.41092 11.8149 6.68093 -3.53423 6.76721 2.7814 -3534 6 43.1526 36.8455 25.2619 -8.14588 -11.3328 3.19442 -3535 4 42.3648 36.774 24.6888 4.17675 -0.750929 11.0286 -3536 4 43.0263 36.2034 25.9927 3.18182 11.8936 -13.2388 -3537 6 32.1279 5.54767 7.01242 2.49094 2.37791 -5.83138 -3538 4 31.9279 4.68363 7.38152 0.218816 -4.41428 4.71371 -3539 4 31.563 6.18782 7.45455 -6.02642 2.24751 5.27561 -3540 6 15.066 21.4965 41.5173 26.6113 -14.2353 0.879596 -3541 4 14.4098 21.4318 0.299313 -13.8163 5.2854 1.00244 -3542 4 14.7314 21.9782 40.7628 -14.3918 6.6959 -6.38566 -3543 6 37.0263 36.0654 5.67599 -8.66989 11.0394 5.08886 -3544 4 36.7926 36.9074 5.26668 1.42879 3.21556 -9.50708 -3545 4 36.6993 36.1724 6.58455 6.67811 -8.44617 -2.15326 -3546 6 39.6264 22.8802 0.345968 -6.61229 0.0560669 1.87747 -3547 4 39.9979 23.7083 41.9266 1.97423 1.58642 1.0556 -3548 4 39.8106 22.8717 1.30105 -0.716498 -2.72173 1.5866 -3549 6 18.4762 23.1875 5.24196 -3.43754 -16.0644 -0.1002 -3550 4 18.2109 24.0785 4.97873 9.26343 12.8459 2.1419 -3551 4 19.3202 23.1705 5.73113 -5.23082 11.7415 -3.58503 -3552 6 34.4866 26.3931 0.410981 -26.1443 -19.9516 50.1306 -3553 4 33.9706 27.0567 0.94736 13.8106 -10.3269 -20.7381 -3554 4 34.4077 25.5868 1.01915 10.7474 25.1704 -28.4611 -3555 6 28.1474 26.0925 40.6196 -28.5345 -18.6936 36.4955 -3556 4 29.0529 26.0026 40.9247 9.18224 2.32741 -2.79367 -3557 4 27.6107 25.644 41.3519 15.6172 17.8969 -31.6189 -3558 6 41.7482 4.39863 30.2421 -5.41295 4.8086 27.4354 -3559 4 42.5847 3.93131 30.2216 8.80522 -6.59194 -7.61494 -3560 4 41.6924 4.68152 31.1831 -5.94926 -0.146025 -12.4776 -3561 6 4.45598 8.30655 29.1222 20.5127 -16.5965 8.52389 -3562 4 3.66946 8.7156 28.7677 -9.60933 13.4518 -0.978151 -3563 4 4.96147 8.97819 29.6123 -10.8114 0.933443 -7.64816 -3564 6 12.9096 9.61234 32.1411 7.95239 -11.3181 7.67023 -3565 4 12.5174 8.82681 31.7782 -9.40951 -4.97415 -8.25208 -3566 4 13.381 9.26623 32.9076 3.83436 11.6436 3.42456 -3567 6 48.6608 16.2478 1.44826 -41.5847 5.12436 -2.24268 -3568 4 49.5977 16.2655 1.51923 27.6715 2.95254 13.2549 -3569 4 48.2356 16.5221 2.2956 18.9339 -8.30142 -14.6437 -3570 6 26.4307 40.0076 21.1903 -9.81311 41.2665 6.04236 -3571 4 27.1749 40.6498 21.1967 -8.04845 -12.0635 0.822588 -3572 4 26.7755 39.1508 21.0026 13.0624 -20.4442 -2.17563 -3573 6 35.79 4.08177 9.00682 -31.6066 0.334495 -4.41207 -3574 4 35.483 4.74976 8.36033 1.0784 -4.66377 5.72074 -3575 4 35.0087 3.86601 9.59196 22.2264 5.21899 -16.6494 -3576 6 52.6895 3.55332 27.8634 16.2443 -8.90238 -17.7273 -3577 4 53.4861 3.5089 28.4695 -19.2533 -5.0216 -23.8454 -3578 4 52.9436 3.34738 26.8904 -3.28408 11.0051 45.9059 -3579 6 48.3169 26.6974 27.3926 25.9077 -23.6746 5.28014 -3580 4 49.0048 25.9927 27.5456 -25.7263 19.495 -6.18754 -3581 4 48.6886 27.4598 27.8411 -2.12981 11.4596 4.51315 -3582 6 24.5097 4.95686 18.7286 -11.1396 -9.34012 13.2359 -3583 4 24.0942 4.18073 19.1756 8.31772 16.1923 -9.35863 -3584 4 23.9484 5.73893 18.8892 6.66511 -10.1227 -0.689949 -3585 6 24.0567 12.4804 28.7686 -1.83015 0.889486 -1.95598 -3586 4 23.1997 12.8888 28.9043 -2.54864 9.49841 4.61676 -3587 4 23.8244 11.6446 28.3683 7.90245 -6.62953 -5.67748 -3588 6 40.1561 27.7426 40.8073 -21.5317 7.14576 -7.35733 -3589 4 40.4932 26.962 41.2601 -12.917 0.0491148 -0.726507 -3590 4 39.1936 27.5721 40.6401 25.9681 1.33069 1.19471 -3591 6 11.9274 13.5458 26.9496 -4.40765 -1.96337 -6.60028 -3592 4 10.9986 13.6678 27.167 -4.51497 -1.32563 0.190923 -3593 4 12.2404 12.8654 27.5442 6.31176 -11.0874 3.59056 -3594 6 52.1902 29.5387 41.394 18.594 -11.3781 3.59259 -3595 4 51.989 30.3087 0.0068425 -9.85392 15.5397 4.91192 -3596 4 53.1003 29.3208 41.6912 -5.64389 -6.04423 -8.59676 -3597 6 17.4867 19.0227 39.1838 -6.27455 21.666 2.75279 -3598 4 17.488 19.586 40.0024 0.860103 -14.9947 -21.9977 -3599 4 17.2876 19.5951 38.4014 5.36511 -12.0476 21.2649 -3600 6 46.2283 27.6807 33.7144 -6.74129 13.676 11.5468 -3601 4 46.0876 28.3582 33.0447 4.86435 -1.49715 -10.0026 -3602 4 45.6533 27.9743 34.4365 0.457797 -3.70748 6.99028 -3603 6 35.8353 29.5439 5.61992 2.49906 -1.59566 -19.7219 -3604 4 35.6527 29.5233 4.66367 4.90114 -0.621078 3.19465 -3605 4 35.4473 30.3766 5.88547 -3.82587 11.7884 10.6864 -3606 6 47.2822 25.7798 30.1513 -10.5766 8.53329 -17.9568 -3607 4 48.1664 25.813 29.7363 -13.2628 3.84456 1.19765 -3608 4 46.6616 26.387 29.6551 21.0058 -12.1546 6.47151 -3609 6 51.3953 12.3638 20.0228 -1.62023 8.46277 -4.73872 -3610 4 50.7529 12.7462 19.4094 4.65296 3.97806 -1.37635 -3611 4 50.8736 11.6867 20.4477 2.10356 -10.8225 11.04 -3612 6 41.9857 18.3757 28.9464 12.9674 -8.39178 -20.9845 -3613 4 42.6678 18.0249 28.3214 -8.5661 8.58724 12.8041 -3614 4 42.4509 18.9846 29.5329 1.95722 -2.13958 -2.01301 -3615 6 53.5955 6.47736 7.49747 -17.4879 -34.0434 -11.6994 -3616 4 53.215 5.56736 7.34717 12.2612 27.0176 1.32153 -3617 4 53.8473 6.47025 8.42428 8.27981 0.813073 3.28926 -3618 6 9.90701 10.6092 26.7593 2.25524 -7.80823 -0.160956 -3619 4 10.2937 10.2906 27.6083 -8.74192 13.2514 -11.8083 -3620 4 9.6719 11.5504 26.8324 5.3909 -8.28719 7.73453 -3621 6 9.32838 39.4044 29.7661 28.1478 19.087 17.9947 -3622 4 10.1636 39.3682 30.3277 -29.6144 2.71186 -18.0569 -3623 4 8.79772 40.1574 30.1092 9.7156 -13.1012 -9.05156 -3624 6 33.3969 4.77935 0.0338577 7.04977 -8.48101 -1.75146 -3625 4 33.7652 5.5373 41.4968 -3.54645 16.0087 -2.35532 -3626 4 34.1271 4.15493 41.8774 -6.76144 -3.49152 6.70786 -3627 6 35.7118 10.6691 34.2465 30.5451 -20.2214 -10.6481 -3628 4 35.199 10.7815 35.0349 -14.696 6.44481 20.012 -3629 4 36.4515 10.0721 34.5187 -16.7263 14.6249 -6.06398 -3630 6 15.1941 17.3851 19.1797 2.70911 -28.1342 -44 -3631 4 15.4897 16.9339 18.3047 -12.3876 19.7973 41.7399 -3632 4 14.2542 17.5546 19.0074 0.407714 2.19657 2.29796 -3633 6 17.478 37.6645 15.4329 -18.9254 1.45878 17.8737 -3634 4 16.9549 37.8023 16.2867 26.4617 -7.60783 -22.0624 -3635 4 18.4074 37.4659 15.6333 -6.79317 3.25497 7.31584 -3636 6 26.2497 8.20945 21.7084 13.406 8.66037 11.1677 -3637 4 26.4123 8.51714 22.643 -13.4745 -7.28424 -22.9055 -3638 4 25.3027 8.1176 21.5293 -5.49097 3.27453 10.4234 -3639 6 0.34 9.90937 15.4047 -28.932 15.8312 -5.67551 -3640 4 1.21626 9.57115 15.2747 8.47529 -16.8828 -5.88536 -3641 4 54.6903 9.41637 14.8207 22.8064 6.49071 10.4803 -3642 6 13.4564 40.6532 9.29599 -22.1307 -5.15585 -0.326819 -3643 4 12.4714 40.4452 9.30279 34.033 7.20134 3.90171 -3644 4 13.9359 39.9749 9.79874 -9.44555 -0.536228 -2.64909 -3645 6 49.5525 25.9167 33.0087 8.30289 -20.978 36.7812 -3646 4 50.1102 25.581 33.7998 -31.2394 16.5759 -41.6702 -3647 4 48.6381 25.5592 33.0807 18.1841 3.33668 -0.378289 -3648 6 37.0921 40.0433 26.4323 -69.9693 32.9093 31.9949 -3649 4 36.1848 39.6472 26.7001 50.2617 0.87061 -16.3943 -3650 4 36.887 40.9984 26.66 23.4133 -30.5831 -16.8038 -3651 6 47.9876 17.8592 12.1588 -8.21233 14.3088 -32.1086 -3652 4 47.5845 18.6288 11.6747 8.44083 -19.6159 16.8154 -3653 4 47.7143 17.8826 13.0665 -7.39134 3.08395 19.3289 -3654 6 27.9663 29.0642 34.1603 1.53587 -18.0299 -1.74725 -3655 4 28.882 28.804 34.3498 -7.37789 1.41773 -2.30399 -3656 4 27.9529 30.0159 34.1809 1.22694 21.8088 1.61581 -3657 6 34.0029 2.78452 13.2168 -24.1529 16.185 8.10865 -3658 4 33.6393 2.32953 13.9926 -4.91269 2.52718 -2.68734 -3659 4 34.7844 2.29731 13.0428 30.2788 -14.7346 -8.06408 -3660 6 28.44 36.053 11.4482 -19.9886 -0.916941 20.5685 -3661 4 28.0041 35.3416 10.9605 0.296796 1.69001 -2.92558 -3662 4 29.0597 36.4216 10.8465 18.9417 8.99323 -20.1084 -3663 6 36.1834 11.364 28.8528 2.80179 -1.8504 -16.6465 -3664 4 35.2026 11.3648 28.9433 17.0081 -1.44193 -10.527 -3665 4 36.4266 11.2403 27.8881 -16.5332 2.0664 24.3605 -3666 6 24.8155 39.488 16.899 1.95651 8.69094 -17.2938 -3667 4 24.2729 40.277 17.0547 2.68209 -2.76325 7.28198 -3668 4 24.7648 39.3887 15.9322 -0.898649 -0.731043 6.96785 -3669 6 49.9432 8.0514 22.8505 -60.8038 -24.1516 -13.0827 -3670 4 49.7668 7.94962 23.7845 10.2147 3.57848 16.1239 -3671 4 49.0378 7.75433 22.5026 41.2245 11.1916 1.13457 -3672 6 52.0935 19.338 10.2277 12.6357 -4.19253 18.0692 -3673 4 51.6063 19.2592 9.39778 1.74616 10.4418 -3.52762 -3674 4 52.4735 20.2434 10.294 -12.5007 -15.5081 -12.5544 -3675 6 24.8386 15.8838 6.12895 -18.3448 14.0073 -0.236232 -3676 4 24.2024 16.3229 6.74681 14.2411 -11.6767 -8.77744 -3677 4 24.4989 16.1625 5.25788 7.11766 -3.93298 6.13727 -3678 6 49.3148 23.6851 8.6303 24.9689 -39.379 16.691 -3679 4 49.2746 22.9584 9.31909 -7.63259 29.9964 -23.4819 -3680 4 48.4638 24.0489 8.3953 -15.5352 0.433996 3.53825 -3681 6 0.208059 10.6481 32.1797 22.1875 -2.28391 4.69689 -3682 4 1.08388 10.2912 32.3483 11.827 -2.86298 -20.6213 -3683 4 54.878 10.581 33.0649 -30.4469 3.74284 18.7822 -3684 6 12.5874 32.9143 13.2407 -35.4131 4.94433 4.95913 -3685 4 11.7345 33.4182 13.1185 22.1299 -14.9844 2.19911 -3686 4 13.2795 33.4792 12.9271 13.1216 10.0242 -5.44208 -3687 6 21.734 32.5657 14.1089 -30.2641 -10.609 17.8788 -3688 4 21.1735 33.3586 14.1938 13.4775 0.171544 -7.80997 -3689 4 21.2373 31.9121 14.6504 18.4585 12.3126 -12.4653 -3690 6 48.1656 34.8484 27.3207 -34.4178 -12.3509 -32.6658 -3691 4 47.5287 35.1179 27.9926 9.598 2.53078 9.45385 -3692 4 47.5616 34.4813 26.6056 29.2581 12.2879 19.461 -3693 6 45.6153 31.2627 36.0943 -37.261 16.4569 21.0579 -3694 4 45.7916 31.8927 35.3904 -0.807743 4.61331 -8.81752 -3695 4 44.8366 31.6277 36.6156 19.759 -7.25665 -17.1647 -3696 6 46.2873 0.296503 14.3622 0.346279 -8.22198 0.0964187 -3697 4 46.2502 1.23933 14.2464 -13.6881 13.1616 4.37405 -3698 4 47.2018 42.0236 14.1712 14.709 -12.2876 -2.23521 -3699 6 14.3299 18.994 40.2006 -30.7379 -32.6603 -9.06287 -3700 4 14.4791 19.2338 39.2972 7.93482 8.11578 -14.4624 -3701 4 14.6855 19.6458 40.7662 17.9566 28.0241 18.1173 -3702 6 14.5596 1.14026 10.2341 26.3279 -2.23148 -9.5451 -3703 4 15.4055 1.22344 9.73443 -17.3894 7.51472 10.761 -3704 4 14.1379 0.381418 9.8097 -7.55267 -3.97863 3.86231 -3705 6 34.4334 40.9199 12.9894 -0.940803 4.29697 -17.7271 -3706 4 34.039 40.5607 12.1545 5.82782 2.6847 22.9711 -3707 4 34.273 40.3011 13.7266 -2.01031 0.481385 -16.696 -3708 6 42.1477 25.6267 33.9881 24.0417 -24.4569 -2.75436 -3709 4 41.6299 25.3559 33.2134 -0.0206438 0.202706 6.41118 -3710 4 42.855 24.9213 34.0976 -22.0628 21.5276 -5.85955 -3711 6 29.1852 22.5895 40.0737 -4.6165 -6.65381 -10.571 -3712 4 28.5947 23.1672 39.581 -0.582997 4.41945 3.85107 -3713 4 29.0675 22.7332 41.0074 -2.93269 3.94269 10.2267 -3714 6 44.8062 18.6252 1.49818 5.72139 3.58279 15.6322 -3715 4 44.9314 18.8801 2.44529 -3.9019 -2.65234 -18.9387 -3716 4 44.0985 19.1782 1.14518 3.29812 2.13948 3.69359 -3717 6 4.47265 10.8135 23.9407 -24.2902 -18.4562 11.3409 -3718 4 5.11906 11.4142 23.6391 22.3407 21.5355 -19.7447 -3719 4 4.51291 10.8829 24.8932 -6.80118 0.381125 6.4492 -3720 6 6.46087 23.0097 28.9948 -0.180046 29.3158 3.74757 -3721 4 7.16357 23.1777 29.6697 -12.977 -15.1924 -17.9731 -3722 4 6.42476 22.0762 28.8013 7.623 -17.0728 6.50296 -3723 6 39.796 25.1427 32.5747 9.70804 -1.04373 -32.2987 -3724 4 39.5377 25.4516 33.4106 -12.9416 11.3784 38.6909 -3725 4 39.6539 25.9218 32.0211 1.09764 -5.16827 -8.54386 -3726 6 40.8629 21.4836 8.86543 0.741147 13.6451 -7.24725 -3727 4 40.6441 21.3431 7.92826 2.29745 -6.5969 8.98303 -3728 4 41.3236 20.7041 9.20266 3.81714 -8.25026 -3.81722 -3729 6 0.635293 1.4289 12.9408 -11.8573 10.3167 -17.0811 -3730 4 54.7874 1.76314 12.6159 9.08744 8.74788 -10.2417 -3731 4 0.270536 0.805051 13.547 10.8795 -21.9384 23.5147 -3732 6 32.6734 29.7199 23.4842 -6.31159 -22.9731 3.95312 -3733 4 32.3164 28.805 23.472 7.37478 14.3791 4.20759 -3734 4 32.5291 29.9779 22.5736 0.738758 10.2783 -10.1223 -3735 6 12.5322 37.1564 20.4866 30.6876 51.3804 29.6269 -3736 4 13.0449 37.1468 21.3313 -10.4644 -1.04639 -16.0138 -3737 4 12.1935 36.3015 20.3752 -17.5174 -49.5479 -6.43685 -3738 6 13.879 14.5208 24.6979 -2.0089 -0.488943 14.0828 -3739 4 13.5126 15.2415 24.1863 -2.86121 7.01781 -5.24136 -3740 4 14.0435 14.8889 25.5812 -0.885703 0.504049 -6.33424 -3741 6 17.5084 27.0547 26.4789 25.7109 3.2743 -38.4356 -3742 4 17.3703 27.9297 26.0618 -4.07905 -12.769 13.7294 -3743 4 18.1097 26.6273 25.8042 -17.4354 5.34049 24.3014 -3744 6 54.4807 9.52867 26.3526 -8.08409 11.5192 21.059 -3745 4 54.0543 10.3952 26.5681 7.59002 -15.9534 -5.94965 -3746 4 54.8701 9.18952 27.1901 -5.85154 7.09102 -14.0848 -3747 6 33.6811 21.5047 24.9231 9.13792 -2.03882 -43.3211 -3748 4 33.6373 21.3676 23.9235 3.71376 4.25849 32.7793 -3749 4 32.846 21.1613 25.2346 -13.4677 -6.75943 10.2286 -3750 6 22.147 35.267 2.89295 -1.50127 3.24452 17.3348 -3751 4 22.2381 34.4 2.47628 0.948748 -2.82555 0.0189077 -3752 4 22.0999 35.1233 3.8735 0.523717 -2.91888 -18.7193 -3753 6 45.3111 5.3951 15.6139 -0.0233827 -18.9082 29.3701 -3754 4 45.1442 5.22798 16.5663 9.63366 2.6406 -14.7931 -3755 4 44.5125 5.84005 15.3428 -8.81534 4.22624 -14.6387 -3756 6 5.67663 7.59044 16.9735 -0.040306 4.08799 -12.5895 -3757 4 5.28026 7.88599 16.128 7.47401 -1.2917 10.5251 -3758 4 6.58383 7.937 17.01 -0.793937 -3.87211 -2.68331 -3759 6 34.58 39.0977 27.2045 1.42769 14.436 -3.31523 -3760 4 34.2907 38.4975 27.863 -0.77861 -26.0942 16.6839 -3761 4 34.0642 39.8725 27.4397 -1.42861 13.6713 -5.6929 -3762 6 32.7657 33.6085 34.293 -22.4583 20.5671 -18.6673 -3763 4 32.1806 34.0441 33.6111 23.9751 -17.2665 15.818 -3764 4 32.4638 34.0082 35.1245 2.30326 -6.42306 -1.86009 -3765 6 30.988 41.2133 32.384 -4.02481 -7.82035 -3.95856 -3766 4 30.2267 41.2202 32.9774 -4.32902 6.50081 -0.328838 -3767 4 31.0509 0.17511 32 -1.2051 10.1503 -2.92525 -3768 6 7.6493 1.59177 27.1464 22.3535 -22.6118 -16.4669 -3769 4 8.41104 1.29664 26.5499 -29.8997 15.2665 16.3611 -3770 4 7.54328 2.53873 27.061 4.65755 9.49162 -4.22239 -3771 6 0.888965 22.101 37.8501 15.4112 -23.8094 -16.9331 -3772 4 1.26739 21.3109 37.3638 -11.0686 24.0488 15.8162 -3773 4 1.18 22.8712 37.3372 -1.61814 -2.27923 2.93708 -3774 6 7.39632 11.121 19.2332 -2.86932 4.41375 3.62624 -3775 4 7.58751 12.0436 19.3904 -7.23274 18.3647 6.41875 -3776 4 8.29083 10.7877 19.1848 5.97481 -12.1861 -3.76707 -3777 6 43.7816 12.5054 37.3126 2.86093 2.78929 -1.28281 -3778 4 43.9727 12.4749 36.3586 -3.06612 0.785718 5.83621 -3779 4 44.6572 12.6706 37.7021 -4.14278 -2.20963 -1.61523 -3780 6 29.0947 33.5132 36.1777 7.61955 17.1376 -26.1106 -3781 4 29.8261 34.0815 35.8667 -13.5031 -6.20718 4.51186 -3782 4 29.4784 33.1216 36.9462 10.9925 -12.9866 20.6523 -3783 6 14.807 4.60084 3.93512 20.0881 9.19657 -13.3363 -3784 4 14.316 4.04064 3.33426 -13.0632 -7.60853 1.79497 -3785 4 15.6236 4.79338 3.42413 -10.111 -0.253003 10.8348 -3786 6 39.0437 6.41097 6.40143 -11.952 4.4329 11.9095 -3787 4 39.4604 7.16771 6.02322 8.12547 27.0605 -0.357881 -3788 4 39.3566 5.75952 5.7919 -0.567413 -21.3616 -5.48613 -3789 6 22.2146 37.9992 40.767 -9.02066 -17.4896 -19.1754 -3790 4 22.494 38.8839 40.5618 6.85259 22.4587 -5.93601 -3791 4 22.4583 37.8811 41.6743 4.99519 -4.33654 23.0463 -3792 6 4.4524 23.286 6.15211 29.8095 -7.21279 -13.1375 -3793 4 3.81791 23.938 6.45512 -14.4589 -6.71938 9.72163 -3794 4 4.31449 22.3781 6.49744 -8.68344 13.1635 4.00749 -3795 6 12.4271 23.7748 9.24631 -1.26755 4.43152 21.3749 -3796 4 11.5607 23.6235 8.88266 -11.7175 -2.77193 -9.11925 -3797 4 12.2509 24.3149 10.0432 11.3809 -1.60307 -13.9136 -3798 6 46.4989 15.2625 16.9679 -12.8481 -2.49131 10.8408 -3799 4 47.085 14.9252 16.2779 8.49272 6.07271 -3.86524 -3800 4 46.8927 16.0486 17.3753 9.61298 -1.72862 -3.23202 -3801 6 34.1182 27.164 19.7815 17.9289 -11.392 6.58771 -3802 4 34.8637 26.5005 19.7508 -17.7467 14.3364 5.12367 -3803 4 34.0077 27.4664 20.702 3.31322 -6.80894 -12.4792 -3804 6 46.9518 13.2225 35.1059 11.5726 -0.299351 34.0182 -3805 4 47.3951 14.0533 34.9197 -1.30218 2.22738 -12.772 -3806 4 46.5273 12.8898 34.3328 -6.46075 0.0352155 -21.0879 -3807 6 50.5846 18.7905 12.5321 0.161349 -2.47544 -10.5355 -3808 4 49.7474 18.3698 12.2516 10.3296 3.30344 0.704295 -3809 4 51.1853 18.7954 11.7538 -11.6392 0.795373 7.80699 -3810 6 32.4849 12.6316 31.9547 13.623 -32.1984 -17.1952 -3811 4 32.7548 11.6805 31.9646 -3.77817 17.5545 -6.43374 -3812 4 32.3724 12.7906 32.8759 -7.39939 11.2146 27.5789 -3813 6 6.21204 19.6856 10.0139 6.84548 18.8235 13.1049 -3814 4 6.54027 20.2383 9.28123 0.761161 -1.37122 2.72757 -3815 4 6.08461 20.3138 10.7689 1.69871 -13.3343 -16.4193 -3816 6 21.5267 21.5372 2.4283 -5.72751 11.2346 -5.82425 -3817 4 21.7624 21.5115 1.48057 4.80944 -6.6677 9.03128 -3818 4 21.9699 20.8013 2.88237 1.68469 2.19074 -10.3234 -3819 6 38.389 23.0803 17.19 -15.8009 11.2489 14.8144 -3820 4 38.843 23.3405 16.3672 7.30113 -17.2523 7.40945 -3821 4 38.5581 22.1678 17.4979 8.57434 6.38113 -15.3203 -3822 6 29.7009 24.9705 22.2505 40.9979 -45.9373 -29.6811 -3823 4 30.2007 24.9541 23.0531 3.51493 7.58579 28.6285 -3824 4 28.9709 25.5198 22.3387 -45.941 40.092 17.1582 -3825 6 30.3026 21.4444 37.7784 -57.0222 17.1687 -23.3742 -3826 4 30.3615 21.3347 36.805 9.38026 -2.23221 21.4717 -3827 4 29.3011 21.6413 37.9016 49.3444 -12.8915 1.59191 -3828 6 11.8723 11.7062 16.3108 -33.4349 -15.0686 -41.1118 -3829 4 11.3207 12.2631 16.8681 -3.98396 2.02201 -1.40695 -3830 4 11.3108 11.5232 15.4705 24.8968 9.48818 41.0096 -3831 6 5.70652 16.9717 10.4705 4.17204 -12.2255 5.26049 -3832 4 4.89872 17.0293 11.0039 1.44556 1.21447 -8.81597 -3833 4 5.85075 17.8293 10.0626 -3.65007 4.58518 2.58079 -3834 6 41.6977 34.1692 35.8837 -2.16171 7.35997 35.3278 -3835 4 41.9434 35.0359 36.2767 -7.39108 -12.3774 -11.2945 -3836 4 41.6554 34.2509 34.9408 0.248654 6.88642 -24.6778 -3837 6 33.755 1.15956 30.1148 26.9661 -5.30311 0.785489 -3838 4 32.8327 1.41064 30.2749 5.35845 -2.81639 19.5818 -3839 4 34.3082 0.981132 30.9387 -30.8845 7.54253 -18.2089 -3840 6 50.3537 18.6141 36.9811 22.0078 18.2711 -1.17075 -3841 4 50.0553 18.9081 37.8421 -3.0234 4.11827 7.26126 -3842 4 49.7241 17.9789 36.6994 -26.7065 -28.1871 -12.5747 -3843 6 24.6713 24.2747 40.2422 -22.5478 13.5437 8.83718 -3844 4 23.7682 24.4281 40.6159 16.469 -5.34198 -8.29501 -3845 4 24.8078 23.3187 40.2616 -1.76472 2.5507 -0.358513 -3846 6 37.3089 22.0315 23.2412 -5.67505 16.6134 8.34505 -3847 4 36.9227 21.8066 24.1113 8.4343 -8.15598 -10.5545 -3848 4 37.8295 21.3076 22.8826 1.63944 -5.88141 4.04288 -3849 6 48.4175 40.505 28.9613 -8.44239 17.3351 -31.8351 -3850 4 48.9168 41.2502 28.5701 -3.67522 -6.90368 3.5913 -3851 4 47.6498 40.4225 28.3398 9.75729 -4.39015 14.633 -3852 6 24.8456 8.73476 16.5822 -4.20971 0.107082 12.7896 -3853 4 25.4166 9.33437 17.0882 0.801486 -3.84637 -6.6671 -3854 4 25.3552 7.93888 16.3774 1.47583 -1.66023 -1.71228 -3855 6 19.2415 22.9983 32.4591 18.0731 -7.21062 -7.32059 -3856 4 18.4972 23.4837 32.0941 -3.55414 -1.2008 3.19393 -3857 4 18.9283 22.447 33.1757 -6.31405 0.951806 3.86493 -3858 6 3.33315 21.6719 22.4471 -31.3651 -15.1442 10.7623 -3859 4 2.72119 22.0562 23.134 20.4737 -7.45649 -18.1084 -3860 4 4.09369 22.238 22.38 14.9219 12.7334 2.89238 -3861 6 10.2287 20.327 12.827 -13.2346 -13.5387 -5.73443 -3862 4 9.59835 20.9044 13.2794 3.30523 -1.6991 -3.3419 -3863 4 9.66163 19.6709 12.3619 8.96671 11.3846 7.22783 -3864 6 9.52445 0.665703 25.3447 51.6699 36.9138 -22.1471 -3865 4 10.407 0.70007 25.8038 -28.3091 -11.588 2.11711 -3866 4 9.73816 1.30323 24.5834 -23.5062 -26.9191 23.3279 -3867 6 10.6629 40.7098 9.64162 -13.7092 -10.0604 -17.7529 -3868 4 10.6663 41.3337 10.3633 -2.25222 9.44489 9.13119 -3869 4 9.9177 40.9644 9.04966 14.1089 -1.91013 12.7496 -3870 6 46.3583 25.2138 32.6818 -7.00173 28.401 24.5039 -3871 4 46.1658 26.0815 33.1748 9.63216 -40.3762 -24.4036 -3872 4 46.6683 25.4845 31.8081 -0.340565 -0.626762 -0.366217 -3873 6 38.9398 3.19835 23.1062 35.7507 -3.98021 4.80576 -3874 4 38.0789 3.42388 22.7807 -21.691 0.0477325 0.592254 -3875 4 38.9606 2.6551 23.9199 -14.9585 3.95725 -7.0779 -3876 6 33.3518 23.6324 36.8776 -10.909 11.1506 22.2396 -3877 4 32.7475 23.7189 37.6717 16.9933 -10.7727 -23.1962 -3878 4 33.5054 24.5617 36.6454 5.48307 -3.56245 -8.14833 -3879 6 51.9403 33.327 25.4307 18.0164 46.0043 -41.5452 -3880 4 51.481 33.1217 26.2288 -14.6019 -1.8433 25.1586 -3881 4 51.8744 34.3335 25.2555 2.07578 -44.1738 12.4077 -3882 6 32.1773 25.016 33.1611 -3.65323 12.5958 -4.40686 -3883 4 32.7417 25.8243 33.1248 -13.2213 -13.5953 2.20315 -3884 4 31.2567 25.3353 32.9959 15.6883 -4.24783 1.324 -3885 6 51.2804 27.7082 39.5058 -12.4055 -13.8576 13.4454 -3886 4 51.6333 27.8214 38.6405 7.56348 -1.28822 -27.9214 -3887 4 51.668 28.4332 39.9759 4.38661 13.1583 16.7532 -3888 6 34.2776 28.325 17.2612 18.5433 -9.6807 0.726105 -3889 4 33.4618 28.7621 17.0499 -21.6526 10.7978 2.5619 -3890 4 34.2928 28.1986 18.2187 -4.64072 -2.98555 4.57564 -3891 6 36.914 8.0422 37.8636 -11.4128 -16.3489 28.1347 -3892 4 37.1972 8.46051 37.0352 12.2245 9.0272 12.2411 -3893 4 37.2151 8.41454 38.7513 -7.64029 -1.69915 -40.4466 -3894 6 34.8876 19.4054 6.12727 15.6033 7.52257 2.15709 -3895 4 34.0531 18.9355 6.15655 -6.74313 -1.04378 -1.75599 -3896 4 34.6977 20.3552 6.00766 0.606543 -4.24654 -1.2187 -3897 6 52.9513 9.46866 7.83406 2.51792 52.5995 -46.1577 -3898 4 52.8182 10.1965 7.1313 21.8169 -33.4663 26.408 -3899 4 52.1097 9.49548 8.25498 -20.9439 -11.3984 23.93 -3900 6 36.2784 5.48477 38.9735 -18.6298 -4.41122 2.56352 -3901 4 36.9459 5.47799 39.6359 15.3203 -14.8264 18.8091 -3902 4 36.5882 6.23606 38.5023 -2.18903 24.2959 -30.3279 -3903 6 10.0091 14.4595 13.4727 4.14065 20.8003 14.1725 -3904 4 10.1735 15.3719 13.8184 -7.35802 -17.2864 -8.75733 -3905 4 9.20522 14.5177 12.9398 -1.57173 0.82324 -0.279823 -3906 6 17.2166 24.3595 39.7866 10.3316 -24.6644 9.74438 -3907 4 16.8461 25.2181 39.6219 -11.8102 15.8188 2.99696 -3908 4 16.9967 24.0978 40.7081 2.51259 6.67153 -9.86646 -3909 6 49.0842 32.5535 7.76087 3.66191 -12.3496 8.85055 -3910 4 48.2705 33.0417 7.89853 -4.87459 2.09702 3.01394 -3911 4 49.5463 32.9698 7.04629 8.35168 7.01386 -14.6239 -3912 6 44.8849 24.3899 5.46806 25.9844 8.68062 13.8603 -3913 4 44.662 24.5947 6.37974 6.74107 7.22813 10.7323 -3914 4 44.0754 24.0079 5.20592 -32.7636 -20.0017 -25.3594 -3915 6 37.3054 29.188 32.8461 11.1431 -5.59449 16.1726 -3916 4 36.8523 29.4202 33.6742 6.83247 1.44061 -4.51415 -3917 4 36.6742 29.3068 32.1579 -22.7291 3.94299 -14.9304 -3918 6 0.907991 24.8221 21.2346 15.0832 19.7352 -4.57067 -3919 4 1.06453 25.2816 20.3717 -1.39622 -8.03116 21.3543 -3920 4 1.45755 25.2897 21.9154 -11.7661 -11.1398 -13.6241 -3921 6 53.0192 2.206 13.0014 -0.818186 11.5483 2.08343 -3922 4 52.7824 1.81345 13.8314 -6.90556 -15.4066 8.50991 -3923 4 53.4537 3.0128 13.31 2.83183 5.68595 -7.528 -3924 6 24.3052 33.9756 13.9324 20.4312 -11.5489 10.0229 -3925 4 23.7773 33.1726 14.1229 5.8111 10.1191 -2.33499 -3926 4 25.2169 33.8698 14.327 -30.0349 3.28274 -10.0023 -3927 6 40.9302 19.2912 0.318024 -15.3988 27.4065 1.86032 -3928 4 41.1581 18.3902 0.297675 9.36546 -44.4479 -0.119704 -3929 4 41.7646 19.7516 0.396104 7.20249 9.57203 1.55489 -3930 6 38.311 32.026 21.5914 -16.5672 24.1097 -12.7773 -3931 4 37.7777 31.3762 21.1012 4.07846 0.69211 1.97712 -3932 4 37.9765 32.9287 21.3171 8.34414 -28.994 10.9395 -3933 6 42.3062 34.9979 16.9676 -25.16 18.3345 5.87282 -3934 4 41.5364 35.0784 17.5803 19.0968 -0.611651 -8.13832 -3935 4 42.7061 34.1505 17.1117 7.13758 -14.417 1.0169 -3936 6 19.559 24.3289 21.9471 -10.3882 -39.985 28.3228 -3937 4 19.0651 23.5074 22.2416 22.0177 25.9498 -5.97634 -3938 4 18.911 24.732 21.3859 -10.0006 10.9377 -12.5795 -3939 6 21.0734 3.08215 14.9508 5.66735 1.93263 4.27485 -3940 4 21.953 3.50152 15.1067 -15.9394 -6.36392 -7.95302 -3941 4 20.9814 2.87634 14.0019 2.73511 2.88399 3.27523 -3942 6 16.4416 12.1461 28.5328 0.855962 3.79198 1.54672 -3943 4 16.9672 12.6551 29.168 -2.37031 -0.949071 -4.41291 -3944 4 15.802 12.7688 28.1665 0.405815 -3.95107 1.98596 -3945 6 29.5641 4.71626 21.7415 17.492 -20.3905 -14.0863 -3946 4 29.717 3.79719 21.4198 0.937107 17.7735 8.56359 -3947 4 28.6765 4.939 21.4721 -9.06619 5.19467 -0.439365 -3948 6 47.4133 12.088 13.4013 -19.6032 -12.6622 16.1152 -3949 4 46.7677 12.2286 12.6843 7.8139 0.82382 7.69043 -3950 4 46.8958 11.6888 14.1608 19.5987 16.3505 -27.3211 -3951 6 26.4348 0.0314913 5.59163 -38.6673 11.9556 1.59378 -3952 4 25.5144 0.513751 5.59151 44.3701 -31.5426 2.21012 -3953 4 26.2832 40.9933 5.84663 -4.6239 23.4679 -5.56234 -3954 6 20.8211 34.8097 41.3598 6.97593 19.5597 16.9804 -3955 4 20.8796 35.753 41.6458 -3.00787 -20.9192 -8.75426 -3956 4 21.5767 34.358 41.784 -4.89338 4.10004 -2.4608 -3957 6 12.6876 17.479 1.38718 -1.79098 16.5747 12.6529 -3958 4 12.721 17.2085 2.3151 1.79447 -6.15344 -4.56661 -3959 4 12.6249 16.7029 0.834077 -0.882684 -12.7315 -6.97767 -3960 6 30.0809 10.1879 8.41184 2.17826 -2.71045 -21.4672 -3961 4 29.3744 10.7602 8.07412 2.70218 -2.7161 1.39802 -3962 4 29.921 10.0821 9.33998 -2.4398 0.0699553 19.6849 -3963 6 36.338 5.45526 23.9203 5.99313 10.0946 16.1749 -3964 4 36.1182 6.35936 23.6236 3.48165 -5.42435 1.21963 -3965 4 37.0503 5.55216 24.5976 -11.7354 -2.45534 -11.6386 -3966 6 34.0137 39.9398 19.5054 17.9066 -9.75089 21.0607 -3967 4 34.5988 39.5452 20.1731 -15.7075 -1.02338 -1.83906 -3968 4 34.6431 40.5289 19.082 -7.6391 9.5881 -14.1485 -3969 6 25.1112 29.0201 17.0007 35.0878 36.529 -22.1514 -3970 4 24.4917 28.3695 17.2244 -30.3786 -36.8419 16.5077 -3971 4 24.8604 29.2867 16.1023 2.15056 -2.21883 6.37313 -3972 6 28.5036 21.3308 6.52422 21.0338 -5.55128 30.7615 -3973 4 28.0688 21.6386 5.71574 5.06238 16.4658 -0.926129 -3974 4 28.989 22.0506 7.05137 -24.5794 -13.751 -30.0602 -3975 6 18.6637 26.1498 0.432001 -8.53447 25.4727 10.2843 -3976 4 18.1393 25.3713 0.533905 -9.92127 -26.6833 -5.54807 -3977 4 18.1707 26.7698 1.00478 10.6071 3.27379 -7.60185 -3978 6 10.9817 29.7047 15.4617 -41.5317 11.7513 13.4553 -3979 4 11.6879 29.3608 14.9846 35.2501 -21.9962 -32.1318 -3980 4 11.3889 29.9926 16.2601 5.02956 8.45945 23.8164 -3981 6 33.4827 3.76017 10.5773 -2.41261 -0.304069 24.838 -3982 4 33.4731 3.39919 11.5182 2.46452 11.5285 -31.0446 -3983 4 33.5847 4.73535 10.6555 -0.240223 -15.9168 2.16837 -3984 6 12.2973 28.805 23.0387 -1.70787 -5.55619 5.61474 -3985 4 12.73 29.6571 22.9381 2.67417 5.94729 -0.690524 -3986 4 11.5024 28.994 23.5653 2.03311 -0.198261 -3.05575 -3987 6 13.0915 10.291 41.0216 -35.9662 5.53295 8.52282 -3988 4 13.8386 10.0408 41.5246 29.6538 -8.48465 17.7322 -3989 4 13.4107 10.5366 40.1733 8.17866 7.18603 -23.992 -3990 6 45.8162 29.981 22.3537 -23.4909 -34.782 -9.94688 -3991 4 46.3605 30.6906 22.6479 19.8522 18.211 11.3118 -3992 4 46.1638 29.1315 22.7274 -3.04842 19.9099 -5.39144 -3993 6 41.5671 12.1372 14.78 12.0724 6.03101 -10.0784 -3994 4 40.8481 12.1001 15.4119 -11.2612 -2.38036 6.73971 -3995 4 41.9114 13.0311 14.8874 5.93112 4.19505 -0.667369 -3996 6 18.1729 7.20363 24.1739 -28.0382 48.7978 3.52623 -3997 4 17.4064 7.85498 24.128 33.406 -18.9268 -1.93395 -3998 4 17.7199 6.38321 24.1568 -14.2968 -40.16 -0.285645 -3999 6 1.47767 28.308 7.57167 -25.5616 27.2209 -25.1393 -4000 4 0.827452 27.622 7.68711 2.49251 -16.9659 6.86802 -4001 4 0.906232 29.0217 7.18328 24.331 -5.18373 6.93061 -4002 6 11.3359 12.3164 24.0718 -23.8013 37.4997 -14.7667 -4003 4 11.6691 13.0224 24.6595 3.51665 -15.1291 3.43827 -4004 4 11.6925 11.4858 24.3227 20.8697 -21.176 20.4973 -4005 6 17.9852 40.4684 24.4198 -2.05389 -13.7174 33.2687 -4006 4 18.291 40.9889 23.6947 8.79563 24.1615 -11.819 -4007 4 17.8495 41.0209 25.2243 7.13458 -7.65509 -20.9696 -4008 6 25.5964 7.43792 34.0141 13.5012 12.0052 -20.5927 -4009 4 25.8913 7.969 33.2287 -3.90825 -14.1502 17.4414 -4010 4 24.6674 7.63663 34.1466 -9.57807 0.741149 3.27376 -4011 6 16.9692 36.3856 7.79034 -41.9934 -28.8773 9.66508 -4012 4 16.1027 35.9203 7.98218 37.4859 8.56847 -14.648 -4013 4 16.8197 37.2026 8.24874 12.7807 20.325 5.07796 -4014 6 12.4125 39.1679 36.8113 4.83627 -30.6012 -9.1357 -4015 4 13.2866 39.4994 36.9682 3.20673 22.8904 8.84646 -4016 4 12.7018 38.3069 36.4569 -23.4958 5.90479 1.90955 -4017 6 23.4443 1.91649 37.7131 1.30421 0.985484 -2.89526 -4018 4 22.7028 1.66545 37.1374 7.60384 11.2995 4.79583 -4019 4 23.7753 2.79308 37.4363 -6.35903 -5.24233 -3.11404 -4020 6 26.6169 34.8556 39.068 -18.8945 24.0174 -16.1573 -4021 4 25.9011 35.0209 39.7003 9.00825 -5.11239 -0.809586 -4022 4 26.448 35.531 38.356 7.64302 -20.2436 14.8851 -4023 6 44.7566 35.572 23.174 8.53117 -4.94531 -21.3447 -4024 4 44.5551 36.3183 23.7275 -7.66893 11.3086 12.1688 -4025 4 44.9082 35.9286 22.2729 -0.906387 -11.1819 10.3159 -4026 6 34.6091 35.4265 26.6991 -7.96701 8.74937 -1.29134 -4027 4 33.7558 35.2865 27.1578 16.0802 3.93421 -4.37465 -4028 4 35.2785 35.5457 27.4013 -9.86041 -2.80018 -4.60569 -4029 6 12.4308 29.8402 9.37325 4.00701 15.5633 13.1387 -4030 4 12.6298 30.2095 10.2592 0.427445 -8.8693 -11.9579 -4031 4 11.9163 30.5385 8.94302 -0.259504 -4.09781 -0.505047 -4032 6 46.4536 41.3715 16.9585 -0.509472 -10.7221 -3.48983 -4033 4 46.3968 0.20327 17.5639 0.209317 7.43894 6.10767 -4034 4 46.3711 41.769 16.0793 0.075994 -2.20044 0.741492 -4035 6 39.1811 31.047 24.0166 -28.3946 14.7902 -31.7872 -4036 4 39.0009 31.2944 23.0615 15.0891 -8.50563 28.3067 -4037 4 38.282 31.1199 24.3765 13.6746 -2.33731 7.34059 -4038 6 40.5375 9.75603 28.9763 9.47615 -22.8392 -16.3574 -4039 4 40.717 8.78834 28.9749 -4.02124 18.0325 0.597023 -4040 4 40.0442 9.94417 29.7674 -4.45736 4.50836 13.2228 -4041 6 33.5752 11.9033 22.735 -22.7947 23.9621 15.9921 -4042 4 33.2963 12.1808 21.8555 7.18969 -8.33444 -8.87292 -4043 4 33.0376 12.5465 23.2695 22.9257 -24.0379 -3.52442 -4044 6 29.0301 38.739 2.44557 13.7604 -11.9544 -20.6568 -4045 4 29.2066 39.6607 2.23242 1.09325 2.62923 1.14408 -4046 4 28.4566 38.7797 3.20164 -8.68487 1.4276 10.4377 -4047 6 51.2789 6.14828 28.303 0.614736 -0.570337 1.8431 -4048 4 51.6973 5.27456 28.1665 -1.53436 11.093 -0.261734 -4049 4 51.6265 6.73477 27.6091 2.17001 -12.1019 4.10374 -4050 6 34.1129 16.6124 14.0322 -32.0491 -20.8609 -4.49638 -4051 4 33.8537 17.5241 13.9801 -4.99199 17.3104 -1.82528 -4052 4 35.0495 16.5739 14.0336 36.3732 5.94549 -0.19423 -4053 6 34.4398 40.0505 7.51971 -1.5967 1.86622 -34.5907 -4054 4 34.4907 40.736 6.82898 6.47702 11.7366 29.0204 -4055 4 34.1466 39.3906 6.89306 -3.09667 -23.6565 15.965 -4056 6 42.5416 22.9885 4.36731 16.709 1.02816 -9.65968 -4057 4 42.6773 23.0677 3.40021 -12.3994 2.37358 9.8727 -4058 4 41.6332 23.2481 4.59133 5.34809 1.54884 -5.45539 -4059 6 1.43335 11.7249 10.5915 17.9648 34.7983 -1.93775 -4060 4 2.18855 11.6351 9.93392 -25.2532 9.63542 18.7746 -4061 4 1.3761 12.7012 10.8984 13.7257 -41.7135 -20.7702 -4062 6 10.0197 17.1509 40.4023 -3.34945 -21.541 12.0793 -4063 4 9.07741 16.8499 40.449 26.596 5.40866 2.75879 -4064 4 10.6028 16.482 40.874 -24.6204 18.7768 -14.392 -4065 6 26.3793 1.16939 23.7984 9.5834 26.112 -20.0106 -4066 4 26.3482 1.63114 22.915 -1.08564 -15.7005 23.7132 -4067 4 26.8817 1.81632 24.3342 -3.35925 -10.5223 -0.68284 -4068 6 4.47487 16.2271 39.0058 33.4959 -10.553 -10.6989 -4069 4 4.63618 15.8937 38.0801 -2.33968 7.70086 24.4633 -4070 4 5.35244 16.1813 39.5129 -32.5033 1.65679 -19.7071 -4071 6 24.3835 39.8482 14.0852 2.84697 7.18038 -0.286146 -4072 4 24.1877 40.6985 13.6429 5.77715 -11.144 2.19115 -4073 4 25.1234 39.4426 13.6288 0.754333 1.29636 -3.16103 -4074 6 19.9701 19.0136 10.1131 -5.22385 -12.8057 23.8822 -4075 4 19.1001 19.3633 10.3498 -0.643873 5.13605 -7.14836 -4076 4 20.1315 18.3631 10.8504 3.64009 16.176 -24.2707 -4077 6 45.2329 15.0638 25.3099 -19.5547 20.2245 12.2671 -4078 4 44.4482 15.622 25.4263 4.62838 7.04728 2.57625 -4079 4 44.8851 14.3824 24.752 0.155489 -22.5403 -14.0061 -4080 6 47.6439 32.9533 29.9771 4.38746 -1.69347 6.40492 -4081 4 47.8622 32.5347 30.8309 -5.05982 6.77924 -7.14273 -4082 4 46.6855 33.0215 29.8843 -3.06966 -4.44082 4.14054 -4083 6 9.30872 14.1631 35.6268 19.7088 14.7601 29.7215 -4084 4 10.221 13.8687 35.4779 -5.99131 -8.3331 -9.89462 -4085 4 9.36538 14.5282 36.5395 -10.4264 -5.45721 -18.9107 -4086 6 0.534978 28.7509 32.1461 -15.0727 14.1973 -4.1115 -4087 4 0.468283 29.1163 31.2513 -2.72678 6.96628 5.64212 -4088 4 0.834469 27.866 31.9601 7.81775 -11.1437 7.49829 -4089 6 26.1375 14.1816 40.8286 20.1166 -40.7048 30.4826 -4090 4 26.3241 13.5573 41.5993 3.0023 20.8863 -27.3959 -4091 4 25.2151 14.3343 40.9319 -22.5068 13.4131 -3.44564 -4092 6 38.0468 1.72227 37.358 -19.6589 11.4537 -4.22791 -4093 4 38.2764 1.77906 36.4154 -1.14244 -2.14966 7.97792 -4094 4 37.182 2.20858 37.4052 20.9639 -13.8426 2.93072 -4095 6 43.3928 21.0193 0.385094 -33.4221 -4.11839 13.5226 -4096 4 43.2305 21.8771 0.864972 20.5484 -13.2955 -16.2126 -4097 4 44.243 20.9573 41.8451 7.78799 18.4844 3.58779 -4098 6 29.7343 12.3918 17.0888 -10.4088 14.6249 -44.7733 -4099 4 30.3573 13.1084 17.3121 -1.69191 -12.5137 15.8564 -4100 4 29.5365 11.7717 17.7855 9.28071 1.18848 24.195 -4101 6 21.0845 11.002 35.643 19.2467 11.9534 29.728 -4102 4 20.8387 11.9292 35.5336 -5.23529 -0.657509 -1.91086 -4103 4 20.6782 10.509 34.9529 -15.7216 -13.7754 -25.5995 -4104 6 24.3584 22.1274 17.054 -19.116 4.6391 -13.6617 -4105 4 24.8062 22.8618 16.6504 0.246813 15.5697 -7.02352 -4106 4 25.0581 21.6899 17.4914 19.3443 -19.237 19.9016 -4107 6 44.2632 9.62803 6.15095 12.4515 -7.11379 4.41615 -4108 4 44.6939 9.46248 5.31272 4.1824 -3.3463 -6.13814 -4109 4 43.3875 9.94101 5.94426 -13.441 6.05535 2.74078 -4110 6 40.7983 2.89203 6.29118 6.30341 -5.06299 2.94692 -4111 4 40.283 3.08384 7.0886 -2.93464 8.08246 -11.2803 -4112 4 40.6425 3.53992 5.58152 -5.48248 3.30556 7.46891 -4113 6 23.4927 29.787 25.2074 -17.9847 -14.6764 23.1638 -4114 4 22.9663 29.9524 24.4255 0.505661 2.84572 -7.25135 -4115 4 24.3189 30.243 25.1366 19.4862 15.0746 -12.06 -4116 6 45.2253 20.6067 7.48804 -4.5495 -5.9569 -0.737791 -4117 4 44.4771 20.6075 6.85512 7.98227 -4.73543 5.3389 -4118 4 45.4897 19.6858 7.65762 -3.7219 7.49041 -4.48952 -4119 6 44.1869 26.5802 16.6604 -2.53584 -23.4697 22.3036 -4120 4 44.4278 26.4187 15.7655 11.491 9.41288 -34.0672 -4121 4 43.9629 25.6676 16.9 -3.51956 3.82806 13.7521 -4122 6 23.5847 27.0608 18.0875 4.92857 -1.63386 -8.1099 -4123 4 23.1417 26.2886 17.6568 -1.85204 16.5134 12.3838 -4124 4 22.9956 27.5067 18.7318 1.2523 -15.787 -12.8337 -4125 6 45.1423 16.1006 8.91925 -12.5826 4.07054 -12.5551 -4126 4 44.1756 16.0018 8.7625 13.8686 2.25455 7.61002 -4127 4 45.2849 15.9649 9.86163 -1.87368 -3.25302 7.37304 -4128 6 39.0195 15.168 5.20911 22.9796 -5.95468 -13.3261 -4129 4 39.8169 15.5451 4.76197 -16.8333 -0.501818 4.44847 -4130 4 38.2997 15.7872 5.12886 -6.79784 14.0419 -3.1922 -4131 6 40.4728 4.77172 20.098 -25.5728 -7.96759 5.38455 -4132 4 41.2852 4.73631 19.62 25.1414 0.345713 -9.53623 -4133 4 40.6586 5.20983 20.9254 2.90807 4.2574 9.49937 -4134 6 35.8334 28.4358 39.8978 -29.6544 -30.7382 0.627816 -4135 4 35.064 27.7738 39.8775 30.8234 30.4338 1.60118 -4136 4 36.4992 28.0138 39.3349 2.0747 -0.608826 -0.916217 -4137 6 26.5626 3.56604 2.67563 -12.8067 -1.70274 -2.52813 -4138 4 26.0244 3.493 1.8476 6.72613 8.7381 24.6483 -4139 4 26.0719 4.09981 3.36162 5.66066 -13.1585 -23.5937 -4140 6 2.95645 21.6514 17.6824 -3.82104 6.40043 0.291571 -4141 4 2.91294 22.1823 18.4797 -6.37673 0.600795 10.7096 -4142 4 3.68258 22.033 17.1814 1.62588 2.51689 -6.09233 -4143 6 12.886 25.0591 25.9256 19.9254 19.7817 -8.37483 -4144 4 13.3104 25.904 25.618 -13.2675 -16.998 3.60223 -4145 4 12.0452 24.9678 25.4656 -4.65807 1.85418 -5.64346 -4146 6 41.5793 20.6554 14.1751 9.92193 3.46069 0.25892 -4147 4 42.3122 20.2044 13.7523 0.767115 -12.7084 -7.64783 -4148 4 41.9959 21.4893 14.4245 -8.84771 2.34114 1.73285 -4149 6 1.24495 39.6039 11.5378 16.0363 -42.6363 3.17437 -4150 4 1.64626 38.7705 11.134 -18.3255 36.4754 4.46196 -4151 4 1.41802 39.4632 12.4909 -5.9615 12.3362 -8.98123 -4152 6 16.0218 39.0109 34.0619 -0.331369 12.6721 -5.4452 -4153 4 15.5475 38.1996 33.7806 5.75571 19.7523 -4.5346 -4154 4 15.9899 39.7855 33.4251 -7.29137 -28.599 9.21448 -4155 6 20.567 7.02475 25.5588 2.3848 7.82756 -0.6535 -4156 4 20.909 7.86076 25.1782 -7.45606 -9.2474 3.61042 -4157 4 19.6275 6.99553 25.3185 5.42042 5.25175 -3.5088 -4158 6 45.1928 25.5902 39.1787 -21.925 2.17874 18.9559 -4159 4 45.8631 26.0435 38.6892 20.8233 13.1115 -15.3132 -4160 4 45.3324 24.6675 39.0115 4.42968 -17.7425 -2.36405 -4161 6 19.9342 40.1138 28.2835 12.5964 -14.0671 -7.25792 -4162 4 19.0067 40.1593 28.0096 1.46425 5.68018 7.52545 -4163 4 20.128 40.8224 28.917 -7.48392 0.334406 -3.99949 -4164 6 26.4878 14.2069 27.3684 6.98603 -7.23951 -28.1548 -4165 4 25.5412 14.1932 27.2537 -20.7302 0.754551 -2.34698 -4166 4 26.606 14.4537 28.2745 0.836708 4.29804 26.5652 -4167 6 51.3489 25.9487 3.45136 10.7849 20.7191 -13.686 -4168 4 51.0453 25.2386 4.01334 -1.8549 -15.8565 1.21982 -4169 4 51.853 25.5737 2.69356 -6.32678 0.0553236 13.0587 -4170 6 20.1633 26.1247 2.67289 8.83438 -16.1267 5.68002 -4171 4 20.5345 25.2411 2.88723 -1.43181 13.9101 -1.64203 -4172 4 19.9438 26.1088 1.72974 -0.778515 0.427063 3.21599 -4173 6 3.13549 11.9681 27.2232 16.3616 22.3682 9.86323 -4174 4 2.68005 12.663 26.7181 4.92926 -3.58697 -0.471129 -4175 4 3.70389 12.4466 27.8862 -15.0224 -10.9098 -14.9284 -4176 6 30.1793 26.3687 4.00051 28.7119 -30.2966 58.1206 -4177 4 30.7801 25.8341 3.46925 -1.584 2.83444 -17.1702 -4178 4 29.6371 26.9341 3.51662 -25.563 30.6813 -37.7958 -4179 6 19.3205 20.6733 30.5441 -31.721 -6.25106 8.6959 -4180 4 19.1895 21.5008 31.0287 11.509 1.10551 -1.6952 -4181 4 20.2026 20.5869 30.2 22.6938 9.52703 -0.947482 -4182 6 13.5381 36.2475 0.344803 0.685356 24.2985 -17.2657 -4183 4 13.9232 37.1122 0.0997808 14.0363 -10.2996 17.9143 -4184 4 12.867 36.2368 41.5779 -17.3214 -19.7281 -1.62589 -4185 6 13.6931 21.7661 35.9637 -11.3229 -11.9655 -19.5688 -4186 4 13.4645 21.416 35.0694 1.68887 6.71419 14.5774 -4187 4 14.5559 22.1488 35.8465 12.3178 6.48213 0.887249 -4188 6 39.4176 1.76287 25.342 34.0854 -16.9064 9.57103 -4189 4 40.0026 2.33061 25.8435 -14.6367 28.4588 7.32056 -4190 4 40.0689 1.04185 25.2643 -19.5027 -7.65211 -10.5764 -4191 6 18.2964 6.13492 35.8264 -1.82227 -5.92686 -23.3299 -4192 4 18.1639 5.26767 36.254 2.04199 12.8657 6.45456 -4193 4 18.4232 6.85005 36.4651 0.375802 -9.94466 7.47089 -4194 6 2.53148 24.639 10.0969 -49.4669 34.6161 -0.50772 -4195 4 3.3243 24.1433 10.0889 43.7683 -7.59463 9.24933 -4196 4 2.65209 25.5465 10.4987 14.0059 -27.2835 -7.72375 -4197 6 35.8204 9.94567 1.34298 17.6587 14.9905 11.506 -4198 4 36.311 10.4135 0.64327 -4.10869 -3.12473 7.53129 -4199 4 36.1923 10.315 2.19711 -13.0886 -16.0695 -26.9686 -4200 6 29.0171 17.933 41.5847 -7.4648 10.4738 41.1296 -4201 4 28.4325 17.2741 41.1888 4.90819 -0.226834 -17.309 -4202 4 29.634 18.3354 40.9804 6.59061 1.40283 -25.0927 -4203 6 46.0097 27.0807 25.8707 -17.7195 2.90801 -6.40423 -4204 4 46.7639 26.9189 26.4445 5.86789 -6.79057 7.62258 -4205 4 45.3727 26.3443 25.9794 8.73043 2.74283 1.98831 -4206 6 28.1087 10.6569 35.9055 -15.3417 -26.5964 -30.9314 -4207 4 27.3182 11.0018 35.4375 11.5227 2.30745 10.116 -4208 4 28.4572 11.2922 36.5111 4.26863 23.9808 15.1461 -4209 6 25.95 20.1976 24.7821 3.31321 9.63686 -4.79579 -4210 4 26.7637 20.7132 24.6155 -9.40037 -7.04512 10.7501 -4211 4 25.7749 20.1865 25.7378 6.19451 4.49283 1.81458 -4212 6 32.2481 30.2487 10.2005 -0.567171 -33.888 25.4585 -4213 4 32.5217 30.8918 9.54162 14.407 -2.03846 -6.18424 -4214 4 32.9483 29.5597 10.4163 -8.30199 27.6945 -16.8968 -4215 6 5.04696 34.3919 23.8165 18.9071 9.10073 -2.65681 -4216 4 5.8517 34.9395 23.7378 -5.43375 -12.4066 7.00495 -4217 4 4.47737 34.8578 23.2154 -15.6684 -1.23826 -5.97721 -4218 6 29.6446 34.9396 23.1073 8.37026 13.2143 1.46186 -4219 4 30.146 35.227 23.8877 -4.79805 -2.96005 -2.8646 -4220 4 29.6355 33.9874 23.1398 -0.169507 -13.2925 4.62646 -4221 6 52.2021 25.2197 36.2484 0.203165 -13.9358 18.8619 -4222 4 51.9199 25.3821 37.1814 5.20177 -0.668093 -22.6011 -4223 4 52.2823 24.2449 36.2046 0.468647 8.20491 -0.432122 -4224 6 6.9564 41.2598 14.9786 17.963 -12.3423 -19.5336 -4225 4 7.05881 41.0384 15.8913 -5.14113 -1.34859 16.0369 -4226 4 7.66895 40.7276 14.5577 -14.5347 12.9973 2.09466 -4227 6 27.6566 39.1405 4.67566 -15.1179 -12.1251 22.0677 -4228 4 26.8424 38.6352 4.89635 10.0979 9.09612 -9.05456 -4229 4 28.2356 39.0161 5.44259 -0.0995191 -2.46215 -4.35417 -4230 6 44.4488 15.8848 30.3925 -17.4686 4.63448 -32.2897 -4231 4 43.6243 16.41 30.3099 13.0937 -10.0294 9.08699 -4232 4 44.649 15.6212 29.457 1.77951 4.94888 23.2191 -4233 6 27.3024 38.1054 13.0907 0.224949 -17.5042 -4.12929 -4234 4 27.6483 37.328 12.5833 -5.61487 10.2238 13.6353 -4235 4 27.1416 37.8221 14.0243 3.20236 0.189733 -16.1751 -4236 6 26.6663 32.9851 36.8362 -23.8807 -10.2072 10.655 -4237 4 27.4028 33.4987 36.5569 24.2269 11.6336 -10.1628 -4238 4 26.2735 33.5165 37.5295 -1.35435 2.25064 8.62378 -4239 6 26.3226 28.1988 31.7158 32.4613 11.5871 5.04411 -4240 4 26.7492 28.3346 30.8217 -6.54697 -0.873531 32.5908 -4241 4 26.9302 28.5068 32.4691 -17.7353 -8.90623 -33.5497 -4242 6 49.2114 35.7792 23.3295 1.46842 19.8344 9.76806 -4243 4 49.8184 36.2235 23.9243 -3.28067 3.63886 4.6357 -4244 4 49.746 35.0988 22.9506 10.5329 -22.9043 -16.5919 -4245 6 44.2369 15.3613 33.5367 -0.695853 -9.37614 14.4104 -4246 4 44.9539 15.1613 32.9326 3.59625 1.2978 -8.28609 -4247 4 43.6189 15.9562 33.0977 0.720121 5.36694 -8.04858 -4248 6 16.6517 35.2697 14.032 -14.9609 -5.91625 -15.8105 -4249 4 16.8478 36.086 14.4923 5.97715 10.4369 8.21626 -4250 4 15.7311 35.3947 13.7134 15.021 -1.16653 5.16189 -4251 6 45.2991 21.4701 12.0564 -47.5016 11.1637 19.3857 -4252 4 45.9844 21.105 11.5386 20.9258 -26.0087 -22.2564 -4253 4 44.5936 20.7913 12.2178 25.8967 12.3347 -6.55717 -4254 6 51.6438 5.33792 20.1099 7.42219 12.4384 36.9688 -4255 4 51.7517 5.79258 20.9932 -2.42789 -17.2577 -23.3969 -4256 4 50.9203 5.81642 19.7 -6.55397 4.36408 -6.3714 -4257 6 22.6153 27.305 0.955308 -12.5158 1.22245 6.52354 -4258 4 21.8819 27.8542 1.31405 9.62632 -7.19502 -8.89748 -4259 4 23.0385 27.8458 0.276527 0.370713 4.24399 -0.0338259 -4260 6 46.8868 12.1467 22.3289 10.3551 9.03073 -1.70047 -4261 4 46.473 12.5446 21.5671 -2.12653 7.07083 -14.4911 -4262 4 46.1639 11.6922 22.7348 -15.0603 -15.1984 17.3736 -4263 6 33.7555 5.60359 25.2366 8.41588 -11.9289 0.48427 -4264 4 34.4013 5.10188 24.7086 -2.4022 4.68399 3.96997 -4265 4 33.0757 5.86414 24.6127 -5.93503 4.46215 -0.558809 -4266 6 44.2476 18.1243 27.2334 30.0322 17.9475 -5.65933 -4267 4 44.0927 18.7931 26.5253 0.465456 -9.97561 17.2792 -4268 4 45.207 18.2464 27.4768 -29.0014 -6.50023 -5.41996 -4269 6 5.27814 37.006 29.0846 -42.995 37.8911 -11.235 -4270 4 4.83357 37.8684 28.7516 22.264 -36.721 16.075 -4271 4 6.19253 37.2033 29.2507 20.6764 5.54169 3.86921 -4272 6 20.033 5.01392 38.9409 6.34377 -32.2179 -4.45843 -4273 4 19.8009 5.56625 39.6765 -4.47316 13.7366 14.9565 -4274 4 20.2948 4.14306 39.3359 -6.8578 18.535 -7.22498 -4275 6 17.9112 2.77214 33.8677 -16.6976 6.01838 23.4157 -4276 4 18.6113 3.34266 33.5322 6.18073 5.31505 -2.96417 -4277 4 17.3526 3.28629 34.5246 17.6921 -17.568 -20.3177 -4278 6 5.56788 23.3774 22.3326 -7.55986 13.5725 18.1102 -4279 4 6.25354 23.3408 21.6412 1.32241 8.57002 8.68476 -4280 4 5.72116 24.1623 22.9232 3.31135 -14.4794 -19.5174 -4281 6 12.7438 28.0244 40.0809 14.6998 26.4392 -25.8726 -4282 4 12.8099 29.0023 40.1455 -0.120572 -14.3051 2.54846 -4283 4 13.1526 27.8611 39.1965 -9.74214 -4.86635 20.6942 -4284 6 50.5283 38.8014 28.4207 -10.7676 14.1923 -1.71082 -4285 4 51.0354 39.5212 28.0559 20.7423 0.788408 -10.014 -4286 4 49.7626 39.3052 28.7255 -7.2831 -13.6434 5.52883 -4287 6 33.5501 8.21498 17.8605 -32.9279 -35.4008 39.405 -4288 4 33.9027 8.87262 17.3189 24.9798 40.0041 -36.6225 -4289 4 33.9074 7.37462 17.5752 8.43731 -7.27798 -4.46199 -4290 6 34.6457 34.7004 17.7764 -12.4293 -15.9601 -10.9704 -4291 4 35.1223 35.3606 18.2944 6.48769 -0.751965 0.253856 -4292 4 35.2388 33.9528 17.5616 -1.14344 9.31979 5.2604 -4293 6 40.7233 5.29016 23.4005 8.26322 -6.33781 10.3585 -4294 4 41.4774 4.87923 23.8731 -9.49225 7.91527 -13.3731 -4295 4 40.0307 4.6112 23.3711 2.34129 5.18948 -0.0201455 -4296 6 16.9127 27.7621 14.4682 52.6044 -4.68653 -2.89351 -4297 4 16.0711 28.1345 14.4444 -59.8378 16.6137 -1.60006 -4298 4 17.4608 28.5627 14.561 1.7801 -9.46587 0.070581 -4299 6 29.0363 14.6633 5.00698 9.76413 -9.29226 13.7719 -4300 4 29.5096 13.8001 4.93115 -9.10936 16.1071 1.03458 -4301 4 28.802 14.7746 5.95339 2.50956 -1.40994 -14.9204 -4302 6 36.8445 17.7203 5.07362 13.6951 -24.032 -28.6565 -4303 4 36.3003 18.4061 5.45056 -9.17068 14.5835 0.43155 -4304 4 36.9783 17.8862 4.10178 -4.81067 2.65881 25.6667 -4305 6 27.7152 25.5071 34.8558 20.6182 -10.3116 10.9196 -4306 4 28.4128 25.1948 35.4689 -8.51497 -1.72528 -14.7569 -4307 4 27.3626 26.2325 35.3632 -10.8781 12.0961 2.58089 -4308 6 24.7577 17.2803 18.064 -3.70908 -2.75228 5.17573 -4309 4 25.2464 17.9619 18.5343 4.21458 5.85634 1.04617 -4310 4 24.0216 17.073 18.6635 3.98676 -0.349172 -5.54229 -4311 6 30.1887 1.57939 5.82314 -15.3902 21.7461 -57.8894 -4312 4 29.5204 1.81013 6.46928 0.301846 -2.58557 7.21893 -4313 4 29.8355 2.03332 4.95505 20.4457 -28.7719 49.9963 -4314 6 37.4518 25.9014 8.44867 -40.4019 -33.5071 29.4213 -4315 4 38.3881 25.8301 8.67833 5.27698 -2.9507 2.74989 -4316 4 36.9261 25.2192 9.0364 31.48 35.4073 -33.2345 -4317 6 24.7717 7.01585 2.25321 22.1725 6.13312 -2.42992 -4318 4 25.3573 6.36243 2.67285 -8.4103 6.94319 2.38151 -4319 4 23.8861 6.6751 2.35128 -10.8992 -4.25211 1.65182 -4320 6 25.7992 38.8457 10.7505 7.22571 37.8744 -16.0906 -4321 4 26.2906 38.615 11.5103 14.31 -23.6918 34.358 -4322 4 26.1189 39.766 10.6411 -14.7913 -5.88601 -10.6141 -4323 6 0.557249 13.5851 28.1314 4.10373 25.7622 10.4527 -4324 4 0.335523 12.7734 27.7191 -4.86664 -22.4284 -15.6315 -4325 4 0.332586 13.4422 29.0593 -0.0574933 0.663208 0.855409 -4326 6 20.4027 17.1068 12.0342 -11.148 -26.8285 -23.5414 -4327 4 20.2541 17.2545 12.9674 -4.18463 -1.09026 14.619 -4328 4 19.9228 16.2663 11.7843 12.058 20.2306 8.20324 -4329 6 30.9875 7.38585 16.6706 43.1327 18.1844 -1.13431 -4330 4 31.2844 7.10043 15.7746 -9.95685 2.73348 15.1831 -4331 4 31.8198 7.8213 17.056 -34.7561 -19.1709 -8.28734 -4332 6 10.1956 5.78615 12.1691 19.1166 9.414 40.461 -4333 4 10.1305 6.30649 11.4071 -1.6074 30.0602 -42.5686 -4334 4 9.61456 5.08708 11.9844 -30.6818 -38.1141 -6.43609 -4335 6 18.4382 31.3444 24.1606 1.21336 -6.12525 2.83497 -4336 4 18.3965 30.3858 24.3134 -0.788465 1.61506 0.642095 -4337 4 18.2608 31.7571 25.0112 -0.825834 1.26386 0.0223154 -4338 6 27.8905 29.2615 29.2809 39.8074 15.5588 -29.008 -4339 4 28.4007 29.5348 28.4528 -32.3375 -5.53357 22.8869 -4340 4 28.6323 28.9656 29.8273 -8.8667 -4.73078 13.1255 -4341 6 38.3648 15.4483 29.7818 29.0993 -31.9427 29.9284 -4342 4 38.2401 14.49 30.0972 1.05022 38.774 -16.5136 -4343 4 39.2299 15.7257 30.2111 -34.0699 1.82394 -15.2271 -4344 6 21.7074 34.7851 5.58078 8.19375 -39.9271 5.99876 -4345 4 21.4944 33.8203 5.80476 0.548141 38.153 -5.97617 -4346 4 20.9458 35.3238 5.82701 -5.25279 -7.50871 2.73382 -4347 6 18.2117 16.8293 1.01571 -12.7233 9.06437 9.63769 -4348 4 17.5846 17.1799 0.363518 5.67247 -6.87112 -0.25098 -4349 4 17.8106 17.1001 1.86952 7.78128 -5.5379 -6.7416 -4350 6 43.5131 18.5098 39.3469 22.8992 -24.809 -24.744 -4351 4 42.9473 19.1501 39.756 -14.025 22.4758 -1.21679 -4352 4 43.733 18.7829 38.41 -14.2449 3.90475 27.8798 -4353 6 17.7973 10.0724 35.5497 11.3899 1.25644 -17.5776 -4354 4 17.9076 9.35875 36.1674 -1.9111 -9.85084 12.7139 -4355 4 18.4727 9.8826 34.8661 -11.1758 5.45367 7.50841 -4356 6 36.5836 30.5676 29.0795 -26.735 36.4018 -15.4516 -4357 4 36.5101 31.4618 28.6208 1.83791 -30.0083 14.6126 -4358 4 37.4767 30.2665 28.9506 20.8385 -5.81304 -4.31186 -4359 6 38.5024 35.9654 10.4302 15.5283 7.61871 55.4477 -4360 4 38.713 36.6589 11.1463 -7.3207 -22.805 -33.4203 -4361 4 38.3781 35.1576 10.9824 1.19538 10.4075 -12.7486 -4362 6 43.3976 18.7941 34.3717 -4.38817 -12.2014 30.3889 -4363 4 43.0627 18.1963 33.6763 0.988603 1.53223 14.3474 -4364 4 43.2603 18.4022 35.293 0.0857578 9.32555 -37.8245 -4365 6 11.0576 40.22 6.11206 -6.0837 -9.04747 -4.15047 -4366 4 11.6426 40.8981 6.46389 1.08734 7.77423 2.35531 -4367 4 10.1474 40.5638 6.06331 9.30243 4.06404 0.87098 -4368 6 48.3282 13.7431 24.4718 -8.87905 25.3224 16.0087 -4369 4 47.8536 13.4091 23.7195 -8.5266 -8.47545 -16.9724 -4370 4 47.8942 14.6072 24.6749 14.3726 -19.4181 -2.72093 -4371 6 1.47819 25.7805 23.7819 -0.0731812 -13.4431 -3.72387 -4372 4 0.822875 26.4404 23.4927 11.4147 5.84295 7.97453 -4373 4 2.19403 26.202 24.2849 -5.19934 9.21725 -1.17005 -4374 6 20.5754 0.0393205 21.1081 25.6075 5.05031 -17.3956 -4375 4 19.8484 0.361847 21.622 -17.4675 -5.38456 12.9096 -4376 4 20.5586 40.9849 21.0455 -11.1839 1.66381 7.6849 -4377 6 37.6642 12.8991 30.7037 -9.9457 -20.8438 -29.8221 -4378 4 37.1371 12.462 29.9889 18.2914 6.1257 8.16018 -4379 4 36.9745 13.1334 31.2979 -14.5618 11.4049 21.409 -4380 6 49.47 17.3794 9.25364 5.30826 8.19981 -9.14457 -4381 4 48.5231 17.6061 9.31556 15.6584 -1.48937 -5.70503 -4382 4 49.8852 17.9254 8.53549 -14.9109 -12.0851 17.4703 -4383 6 34.3662 5.35535 17.144 13.1974 2.57034 -29.0571 -4384 4 34.5198 5.2998 16.166 0.54303 4.43319 20.4174 -4385 4 33.4623 5.07036 17.243 -16.3394 -6.24992 8.38082 -4386 6 14.7833 27.6665 0.0728061 -6.74966 -7.64198 -7.69033 -4387 4 13.9925 27.8402 41.4242 12.1928 3.48747 9.75107 -4388 4 15.1668 28.5017 0.401621 -7.96817 -0.0208253 -5.02821 -4389 6 48.8656 15.5206 20.7458 -9.86138 0.136748 20.6241 -4390 4 49.0651 16.3952 20.4263 0.209458 6.72405 -7.85333 -4391 4 49.1204 14.8922 20.0789 6.79298 -9.16117 -16.8166 -4392 6 23.807 40.3882 20.3905 -3.398 23.5063 24.1729 -4393 4 23.5208 41.0259 21.1064 9.42377 -19.8715 -22.5683 -4394 4 24.7282 40.1652 20.6096 -6.91059 4.34471 -3.10789 -4395 6 35.1847 31.5046 13.7021 -31.0181 23.9456 -35.1619 -4396 4 34.2309 31.3725 13.4471 24.927 2.88592 7.27171 -4397 4 35.3946 30.8036 14.2945 4.95161 -20.634 19.3451 -4398 6 10.9658 9.01332 39.5058 -15.2714 21.9147 -18.395 -4399 4 10.5965 9.92979 39.4 9.97221 -25.6919 2.69722 -4400 4 11.1763 8.90125 40.4322 -2.36933 4.41176 3.08643 -4401 6 53.2091 4.88966 16.6226 -14.1926 -12.3632 -40.3028 -4402 4 53.7513 5.3458 17.242 7.58091 5.46958 35.753 -4403 4 52.4727 4.38631 17.0042 6.19997 4.37068 9.30068 -4404 6 7.84194 33.803 26.1542 28.433 15.6582 -32.2535 -4405 4 7.6241 34.0763 27.0539 6.31302 8.01731 -0.629847 -4406 4 8.43319 34.4994 25.6777 -29.4311 -29.3345 32.8186 -4407 6 31.3263 27.9445 6.27534 4.23256 -31.0286 -11.1959 -4408 4 31.9071 27.4889 6.92578 -8.71467 11.4818 -6.48617 -4409 4 31.157 27.2952 5.54778 3.06851 13.2477 11.4148 -4410 6 31.3665 2.16522 41.0549 8.67281 8.84877 18.675 -4411 4 31.764 2.22522 0.0553479 -13.0589 -8.62932 -24.7178 -4412 4 31.1679 1.24258 40.8683 -0.324156 -6.15668 4.61941 -4413 6 33.7659 4.25511 35.8987 -17.0312 -3.82062 1.06926 -4414 4 34.343 3.86214 36.5812 -9.75418 2.24627 -3.55813 -4415 4 32.8029 4.08293 36.1352 33.1171 1.27305 -1.46623 -4416 6 47.9658 16.0637 29.8469 2.67107 -7.93457 21.4822 -4417 4 48.7643 16.2814 30.3583 0.589987 0.219824 -12.8585 -4418 4 47.4335 15.6159 30.5321 -1.60863 4.8928 -15.0046 -4419 6 49.3312 10.0914 28.5924 -0.28152 -2.80953 -5.35856 -4420 4 48.5695 10.6519 28.8218 4.15282 -2.34898 -5.74021 -4421 4 49.4995 10.1231 27.6243 -2.44246 2.9592 14.5426 -4422 6 21.4058 27.7857 29.7524 8.26148 -8.5709 13.934 -4423 4 21.8935 27.2574 30.4222 -7.07544 0.199766 -18.4014 -4424 4 21.2999 28.6278 30.1835 -3.48366 18.9655 1.67033 -4425 6 11.6744 39.4982 25.8468 7.90293 7.18169 -2.58674 -4426 4 12.2285 38.7361 26.0681 1.40058 3.92388 1.36909 -4427 4 10.8023 39.1241 25.7384 -12.6269 0.672841 -0.990747 -4428 6 22.9696 39.3076 7.85132 -6.07512 -3.4122 -1.68244 -4429 4 22.2682 38.6524 7.98148 0.173976 5.86283 1.52023 -4430 4 22.7132 40.0561 8.41581 1.67877 -3.24138 -2.90234 -4431 6 42.551 35.9177 31.3369 11.821 -63.1978 11.5341 -4432 4 42.5803 35.466 30.4647 -4.4966 22.226 11.3725 -4433 4 42.4036 36.8376 31.2573 -6.84366 36.9754 -14.9488 -4434 6 33.6582 14.7374 3.97797 20.0935 -7.17859 -40.4554 -4435 4 32.8645 15.2412 4.10613 -20.5582 11.3796 6.05129 -4436 4 33.8494 14.8388 2.99484 -4.26498 -3.76663 30.6135 -4437 6 36.6985 8.59579 17.521 17.5186 -20.4505 -17.8166 -4438 4 37.2174 8.05238 16.87 -10.1577 15.2162 18.3492 -4439 4 36.2061 9.2161 16.9727 -6.85471 3.87096 1.58869 -4440 6 20.8134 32.4132 17.3224 -0.15138 -19.2041 8.32641 -4441 4 20.2101 33.0681 16.9297 -8.31182 -6.81981 10.9196 -4442 4 20.3788 31.7527 17.9441 5.10322 26.2393 -19.6477 -4443 6 20.7088 35.3183 14.0957 -11.7768 -25.3725 -13.8548 -4444 4 21.261 35.5893 13.3574 6.77827 9.37653 -4.07387 -4445 4 20.8679 35.9028 14.8214 6.04206 13.2639 9.85712 -4446 6 20.2377 2.51389 40.1721 -7.12285 -8.41588 24.6249 -4447 4 19.7963 2.31331 41.0421 14.3479 1.04867 -24.2175 -4448 4 20.7189 1.71371 39.9103 -4.456 1.41042 1.49289 -4449 6 15.0332 14.4679 0.20602 13.2809 -6.14192 -34.7112 -4450 4 15.5535 13.6508 41.8516 -13.9549 30.8146 5.37449 -4451 4 15.3124 15.2392 41.5458 -1.11857 -25.4589 11.3055 -4452 6 24.8198 37.3334 18.5262 -9.71694 12.1129 21.4379 -4453 4 24.5044 38.0178 17.9266 6.55828 0.975012 -4.85481 -4454 4 24.4839 37.6255 19.4009 7.37292 -12.3795 -13.3571 -4455 6 3.16023 27.7824 5.25746 -7.59771 -9.49442 8.09122 -4456 4 2.57386 27.9573 6.05068 26.7372 -11.3185 -11.6141 -4457 4 4.04718 27.3724 5.4685 -26.4098 5.90831 3.92345 -4458 6 37.1274 39.059 36.0582 -20.0626 39.3499 3.12364 -4459 4 37.4397 39.697 36.7497 0.155645 -22.9334 -11.3782 -4460 4 37.5741 38.2261 36.1006 18.9616 -13.4483 8.05827 -4461 6 41.3496 16.372 3.85306 -8.55617 -26.9153 -3.74777 -4462 4 41.2863 17.3336 3.84263 10.0449 1.9656 13.5452 -4463 4 42.0245 15.9886 4.46176 -7.16622 24.1057 -6.4954 -4464 6 15.5715 3.1806 35.3543 4.49903 -8.79025 -44.1337 -4465 4 15.0747 3.51322 34.5661 7.45265 -4.29831 20.3405 -4466 4 15.2394 3.62675 36.1076 -11.9729 17.6287 21.2524 -4467 6 33.1697 24.252 7.98021 17.4163 -35.2043 24.5175 -4468 4 33.373 24.4892 7.07941 -5.88693 14.0606 -13.9779 -4469 4 32.5854 24.8767 8.38373 -10.6809 23.5743 -3.02942 -4470 6 35.8792 29.7453 15.5891 -14.351 2.75051 -7.10357 -4471 4 36.7674 29.6271 15.8378 44.9858 5.9786 2.16229 -4472 4 35.4705 29.0828 16.1298 -19.5083 -3.35284 8.18061 -4473 6 17.5951 36.8258 41.8642 -13.8657 0.640745 -39.4401 -4474 4 18.0986 36.7885 0.752491 19.5286 0.61142 14.8967 -4475 4 18.204 36.9888 41.0995 -4.16013 -2.78766 23.3657 -4476 6 26.5622 4.14757 31.1303 -11.2209 -47.8968 -15.8259 -4477 4 27.2883 4.63526 31.456 28.856 27.2634 11.544 -4478 4 26.9475 3.23966 30.9928 -12.9924 23.1667 5.46977 -4479 6 31.9456 1.33308 34.4467 -12.9904 6.64728 -11.4505 -4480 4 32.8071 1.19449 34.8725 -11.0783 -3.65615 8.33208 -4481 4 31.1956 1.0725 35.0172 18.2758 0.413953 2.527 -4482 6 24.503 14.7492 2.38048 9.24208 -0.0712211 -0.802907 -4483 4 24.1928 14.0003 2.93847 14.4388 11.7071 -7.35684 -4484 4 25.4689 14.9243 2.53228 -19.8697 -9.93034 3.69906 -4485 6 25.7634 20.9148 27.525 0.946636 -0.977661 -1.30084 -4486 4 25.4997 20.5428 28.395 3.38508 9.32598 -11.7317 -4487 4 25.6529 21.8806 27.5755 0.284497 -3.23384 4.14496 -4488 6 18.1477 40.1511 30.6505 2.638 -12.7558 5.82509 -4489 4 18.5379 39.2542 30.773 0.361891 20.0487 -3.45439 -4490 4 18.8736 40.7943 30.5754 -0.793328 -5.73314 0.616918 -4491 6 46.8137 23.9108 24.5765 -6.45001 25.2139 -38.2053 -4492 4 46.156 24.4917 24.0674 25.2521 -23.4518 17.6745 -4493 4 47.3533 23.4819 23.8873 -7.92808 3.44465 4.72259 -4494 6 45.5993 22.6806 26.5072 -4.87261 3.12825 -8.14378 -4495 4 46.0946 22.9584 25.7273 -3.42504 -3.72677 5.16847 -4496 4 46.0209 23.1613 27.2227 -5.79148 -3.32105 5.25932 -4497 6 20.0977 4.47574 26.7104 -1.85738 36.2438 14.3308 -4498 4 20.3766 5.37803 26.4593 -10.8474 -9.08605 12.6513 -4499 4 20.6066 3.98633 26.1049 14.7704 -34.5311 -24.6657 -4500 6 35.268 26.6035 12.5547 25.3434 4.5593 25.1203 -4501 4 35.7054 25.7374 12.5354 -13.4481 2.49909 -6.64065 -4502 4 35.8431 27.0669 13.1929 -15.092 1.56141 -12.9558 -4503 6 3.25549 33.9664 12.2985 -21.2488 -6.99508 3.93395 -4504 4 2.30606 33.7392 12.3085 7.5225 -4.25393 -1.25154 -4505 4 3.25844 34.917 12.332 8.53638 16.5693 1.24934 -4506 6 36.6808 1.27299 25.5856 -28.051 -2.86161 17.5249 -4507 4 37.6164 1.46673 25.6835 8.21338 5.71919 3.59986 -4508 4 36.1703 1.6124 26.3685 15.6278 -2.9361 -18.4357 -4509 6 16.8737 4.664 24.0353 -31.9925 -2.01789 -27.2632 -4510 4 15.8786 4.73848 23.8401 40.5517 -2.65221 8.73903 -4511 4 17.2589 4.19458 23.2519 -3.48506 7.68373 17.7614 -4512 6 39.6701 15.0742 7.83356 -1.71206 -7.05123 2.14494 -4513 4 39.2725 14.2274 8.02711 2.44544 -9.24519 17.4119 -4514 4 39.3892 15.1326 6.9218 7.69265 14.011 -7.76766 -4515 6 9.96731 20.1909 2.92864 -13.1382 1.0323 -16.144 -4516 4 9.71565 20.5309 2.05786 3.65664 7.03968 6.64426 -4517 4 9.8995 19.2377 2.78093 4.24026 5.10291 12.3576 -4518 6 23.4077 4.6159 15.27 -3.48308 -16.1533 -1.5067 -4519 4 23.619 4.71624 14.3536 6.29203 -7.01184 -22.1313 -4520 4 23.1672 5.50294 15.4683 -4.33935 19.8524 20.6561 -4521 6 23.5267 41.6518 17.9122 -9.44104 0.807914 21.3506 -4522 4 23.7067 41.2659 18.7956 7.59245 -0.294373 -11.029 -4523 4 22.6339 0.0834245 18.0732 1.82991 3.48892 -13.1537 -4524 6 30.9316 4.82324 1.33107 45.9774 51.3713 7.99935 -4525 4 30.5768 4.02682 1.05687 -28.0042 -54.4029 -17.3695 -4526 4 31.8094 4.8761 0.879215 -15.6392 -0.833181 8.5221 -4527 6 29.2201 33.7587 18.5991 58.073 2.92721 -1.85527 -4528 4 30.1837 34.1183 18.6008 -42.2538 -17.2347 0.0641557 -4529 4 28.6837 34.5413 18.5643 -15.6262 17.5996 3.33909 -4530 6 23.1221 16.7099 3.68521 11.8431 -16.3115 0.0733348 -4531 4 23.6562 16.338 2.95547 -9.45134 2.67217 9.8165 -4532 4 23.048 17.6538 3.54099 -2.31098 6.59774 -1.54538 -4533 6 34.8961 26.7639 31.7325 -1.99602 4.46994 3.67284 -4534 4 35.0929 27.7139 31.562 -2.18198 -17.8875 -5.58085 -4535 4 35.0252 26.2302 30.9312 2.47742 18.1005 -1.54363 -4536 6 7.11189 40.7663 20.959 14.901 4.90705 15.7674 -4537 4 6.49418 40.4573 20.3006 -5.17655 -2.88906 -15.6427 -4538 4 7.9749 40.9101 20.5297 -6.61986 -3.78335 -7.15935 -4539 6 52.4451 9.69387 11.9379 -8.46192 -13.0679 -16.1645 -4540 4 52.1167 8.90553 11.4509 5.46474 18.3719 13.4625 -4541 4 53.1134 10.0871 11.3593 -6.16158 -0.354597 4.80602 -4542 6 12.0344 32.7576 27.7445 1.28323 7.36678 12.5499 -4543 4 11.2848 32.2741 27.3627 7.37999 2.33687 -5.47139 -4544 4 12.7987 32.654 27.1746 -1.40521 -5.62475 -4.84597 -4545 6 15.7821 18.5441 0.84801 8.76354 -4.35468 -11.8188 -4546 4 16.4439 18.9467 1.42581 -3.0166 1.81121 1.10538 -4547 4 14.9492 18.5892 1.29924 -12.8156 0.756803 9.02992 -4548 6 30.9925 13.9418 7.42386 -4.40747 -9.92517 -19.1249 -4549 4 31.0137 13.4754 6.53341 6.38174 17.9129 28.0089 -4550 4 31.6996 14.6103 7.52177 -5.32565 -11.3142 -7.68087 -4551 6 23.9405 39.5605 3.5435 10.8606 -6.43074 -8.73391 -4552 4 24.3095 38.7805 4.04208 -2.00396 18.4511 -18.0645 -4553 4 24.6123 39.8651 2.88148 -9.69774 -9.50421 15.8523 -4554 6 53.2462 13.9551 2.00337 -15.5118 -12.0942 -3.71099 -4555 4 54.104 14.269 2.28215 12.5804 5.35006 1.30654 -4556 4 53.0522 14.3304 1.13281 7.32968 -0.777694 2.32044 -4557 6 29.4483 26.4268 7.81741 -0.171572 11.4439 -18.4732 -4558 4 29.8672 26.7876 7.00927 -3.33338 -4.99995 18.6366 -4559 4 28.5088 26.3872 7.58736 -4.03891 -2.78124 5.15679 -4560 6 24.6251 23.6043 31.0935 -26.8137 17.7603 -44.4691 -4561 4 23.7139 23.2229 30.9355 29.773 11.0738 8.78977 -4562 4 24.7983 24.2076 30.2965 -2.98074 -30.8217 36.523 -4563 6 33.658 19.3188 40.511 -4.29932 4.0975 7.85681 -4564 4 33.8365 18.6271 41.1728 0.0947513 0.993086 -5.72158 -4565 4 34.3002 19.2334 39.7953 0.390848 -1.03282 -3.03706 -4566 6 0.558986 35.9852 14.2205 11.1667 11.0015 21.0521 -4567 4 1.21386 36.1432 14.9149 3.92292 -5.96876 -2.97707 -4568 4 0.043734 36.7876 14.3014 -15.3768 6.08493 -10.5247 -4569 6 7.05222 12.7587 15.7802 -26.1824 -15.4106 14.8382 -4570 4 6.35773 12.5373 16.4499 19.2033 7.53925 -13.5919 -4571 4 6.88557 12.0803 15.1093 4.12905 5.75416 0.888 -4572 6 7.8802 3.87979 22.4264 4.564 -30.6165 13.1651 -4573 4 7.61737 4.55637 21.8154 -5.12813 13.4305 -13.5146 -4574 4 7.59435 3.01808 22.0419 3.92228 16.9329 8.71162 -4575 6 50.747 32.0919 16.246 0.584829 29.9532 -6.88448 -4576 4 49.8575 31.8158 16.477 -3.66132 0.0213613 -0.234359 -4577 4 50.6533 33.048 15.9617 2.92819 -31.696 10.1835 -4578 6 15.3083 18.2099 30.0577 17.4273 -12.3999 25.5818 -4579 4 14.8795 18.523 29.2753 -13.2188 2.60124 -19.4058 -4580 4 14.9888 17.3027 30.2404 2.47215 8.3937 -6.40515 -4581 6 36.7253 25.4508 33.3862 -30.1432 30.6395 -17.6873 -4582 4 35.9871 25.9696 32.8546 42.334 -36.2451 27.5582 -4583 4 36.7428 24.5171 33.143 -7.68133 1.91065 -3.3758 -4584 6 16.5208 21.8449 20.262 -11.2097 8.64672 -3.63533 -4585 4 16.6085 20.9267 19.9682 1.68058 -0.497742 -2.90804 -4586 4 16.3112 22.3946 19.4823 4.36577 -8.59001 6.07269 -4587 6 44.2833 3.11948 30.0766 -7.99673 -6.73576 30.9987 -4588 4 44.2005 2.2232 29.7402 -0.794022 -7.70278 -4.62871 -4589 4 44.5183 3.67066 29.3503 7.77568 15.2131 -24.9404 -4590 6 51.0808 14.1269 27.7758 -27.047 -14.2895 -4.28411 -4591 4 51.175 15.071 27.7901 8.66575 19.7266 0.878182 -4592 4 50.1173 14.0309 27.5969 15.0189 -4.76366 3.10402 -4593 6 54.1497 15.8755 27.1203 10.9044 -5.07506 15.753 -4594 4 54.6247 15.0341 27.411 -19.35 18.5916 -21.6107 -4595 4 53.6213 15.8397 26.2863 11.6919 -13.2292 13.7718 -4596 6 26.7269 15.1716 34.5247 3.07047 6.28357 -2.56105 -4597 4 26.6547 16.15 34.5201 9.87746 -16.6036 -4.19036 -4598 4 27.4477 14.9176 33.917 -5.54963 13.4877 1.89491 -4599 6 34.6713 2.21044 27.481 35.3652 -9.42756 14.1603 -4600 4 34.3712 2.0217 28.3795 -9.10436 3.38048 -0.887416 -4601 4 33.9282 2.37922 26.9258 -24.4077 6.67858 -6.22498 -4602 6 36.3012 17.6491 40.388 5.86113 23.4658 6.44349 -4603 4 35.7206 17.1804 39.7974 -3.43874 -12.7236 -2.47465 -4604 4 36.6864 17.0408 41.0377 -6.22241 -0.114851 -7.42509 -4605 6 26.2819 0.194243 33.0916 -21.1162 -1.74839 5.89968 -4606 4 26.0541 0.792538 33.818 7.17118 8.51167 2.05738 -4607 4 25.4361 41.6393 33.0097 0.772233 -7.73624 -3.23605 -4608 6 5.19547 35.5715 31.6247 14.6733 -21.492 26.4929 -4609 4 6.10271 35.831 31.8735 -9.75028 2.17691 -1.53344 -4610 4 4.97694 36.0548 30.8519 -3.41417 18.4244 -29.6169 -4611 6 20.2195 22.0294 35.119 8.25657 -3.203 11.321 -4612 4 19.9286 21.1888 34.7559 -2.68712 -4.78598 1.15285 -4613 4 20.5567 21.7901 36.0152 -5.29706 4.10974 -20.8318 -4614 6 15.9087 36.5843 36.9399 0.69981 -30.9087 31.3945 -4615 4 16.5764 37.2836 37.0377 -3.33596 -3.14632 -1.27145 -4616 4 16.032 35.9777 37.754 -5.87689 21.7482 -34.0408 -4617 6 30.95 22.3912 3.57027 12.227 -51.3484 -20.5494 -4618 4 31.0645 22.6091 4.4902 1.82476 2.59415 19.1922 -4619 4 31.2691 21.4218 3.50648 -13.7255 40.3499 2.75328 -4620 6 47.0405 8.41049 14.2025 -7.26712 -13.7585 -23.7685 -4621 4 46.2225 8.31623 13.6472 18.9804 2.55096 13.7682 -4622 4 47.7321 7.85584 13.7597 -18.0416 11.4216 8.02226 -4623 6 34.1106 18.627 3.15563 -0.4946 23.1394 22.2065 -4624 4 34.672 18.2914 3.86301 0.996255 -3.71784 -4.49801 -4625 4 34.2399 18.1173 2.36738 0.542984 -13.2578 -17.3669 -4626 6 26.7976 25.3916 12.343 -23.6037 -44.5624 17.4882 -4627 4 27.2059 26.2338 12.4335 13.1462 29.8808 4.32264 -4628 4 26.6887 24.995 13.243 7.37483 11.5945 -21.6739 -4629 6 22.6215 25.7777 30.8835 17.9212 -8.3502 11.6983 -4630 4 23.3826 25.7056 31.4928 -6.70991 6.16838 -4.71983 -4631 4 22.2455 24.8881 30.8847 -4.10822 -0.13742 -3.2228 -4632 6 23.6315 9.78689 35.7599 5.48292 -2.30097 -0.625566 -4633 4 22.8113 10.2893 35.7248 -4.77612 1.7474 -0.383276 -4634 4 23.3643 8.87406 35.5171 2.31753 16.9109 3.97959 -4635 6 10.4044 36.7742 9.63922 -25.0741 -4.1625 3.51028 -4636 4 9.48479 36.4361 9.55892 17.1497 7.1291 1.06445 -4637 4 10.7029 36.9295 8.73946 3.49181 4.27039 -8.54773 -4638 6 4.00239 32.4234 25.8687 17.3833 10.7639 11.9139 -4639 4 4.35688 32.9952 25.1699 -1.7627 -0.965582 -1.95819 -4640 4 3.3252 31.8731 25.4905 -12.2764 -14.2405 -10.2138 -4641 6 29.0717 26.0252 18.6551 27.2015 -27.7815 2.54409 -4642 4 28.1485 25.9947 18.9226 -9.28828 -8.18845 2.68073 -4643 4 29.5616 25.1801 18.9271 -24.0321 31.3207 -7.4501 -4644 6 15.3034 1.33037 27.9713 -8.15532 13.2931 -1.88459 -4645 4 14.9824 0.900448 27.1643 -4.10476 8.37726 9.18093 -4646 4 14.8435 2.19317 28.1161 8.64797 -17.4448 -9.70896 -4647 6 48.6122 2.88813 22.9601 -14.0575 20.6462 10.9468 -4648 4 48.3097 2.01316 22.7294 4.97712 -8.72373 -1.92059 -4649 4 49.4728 3.0448 22.5739 5.56154 -9.57595 -10.4155 -4650 6 53.0134 0.348391 19.7218 2.72624 -2.60203 -3.14968 -4651 4 52.5877 42.0257 20.5538 -0.625041 0.289898 3.74318 -4652 4 52.305 0.305612 19.0628 -0.905041 -0.864478 -1.55308 -4653 6 1.39118 17.4858 17.9447 -8.50794 14.6458 12.7327 -4654 4 1.24353 17.4779 16.9894 -1.31782 -10.0732 -1.96873 -4655 4 1.47925 16.6123 18.3551 -1.8326 -9.29856 -10.4725 -4656 6 37.8975 19.0277 37.6053 -28.6618 15.029 -11.7184 -4657 4 36.9647 18.7897 37.7838 11.6122 1.96204 1.16191 -4658 4 38.4406 18.4447 38.1174 10.3965 -16.3488 12.6679 -4659 6 26.9855 30.3558 38.071 9.50079 1.40194 -4.36533 -4660 4 26.0886 30.216 37.7369 5.39533 7.19535 -1.12484 -4661 4 27.2954 31.2276 37.7499 -13.0308 -11.5285 -0.168161 -4662 6 20.0885 18.5747 3.04679 -6.02291 21.5949 -15.2672 -4663 4 19.9787 17.7407 3.50085 7.53739 -11.7285 12.3408 -4664 4 20.8981 19.0299 3.33477 -4.38138 -14.9723 0.744253 -4665 6 35.0861 6.94018 4.08702 3.04221 -3.62035 -0.583554 -4666 4 35.6351 7.18342 3.33325 6.4301 -2.1748 -2.62446 -4667 4 34.2564 7.39563 3.93984 -10.6534 0.652929 2.2495 -4668 6 22.2213 37.08 31.2556 -28.1532 13.1327 42.6182 -4669 4 22.1563 36.8958 30.3458 -2.68084 -5.78815 -35.014 -4670 4 21.2899 37.3194 31.5407 35.2494 -6.03647 -12.8067 -4671 6 12.3954 22.364 41.8234 21.4337 26.9075 -8.21443 -4672 4 12.9612 23.1595 41.5956 -22.2624 -27.6618 12.5485 -4673 4 11.7092 22.295 41.1522 0.74395 2.83494 0.343647 -4674 6 43.2331 30.3213 23.157 26.8689 32.5799 1.85734 -4675 4 44.1495 30.0558 22.8796 -21.7207 5.89602 6.32158 -4676 4 43.3514 31.2801 23.4416 -6.45211 -30.9956 -6.78246 -4677 6 16.5257 8.07813 16.6617 -19.4309 -12.5216 11.6481 -4678 4 16.3886 8.34983 15.7476 7.00958 2.01583 -5.14722 -4679 4 17.4107 8.32004 16.9428 8.9294 8.4681 -2.86418 -4680 6 10.0506 8.65043 31.7756 -2.39508 10.2278 -10.4865 -4681 4 10.14 7.97578 32.4103 1.95442 -36.8206 12.1998 -4682 4 10.116 9.39125 32.3649 -0.107045 27.388 0.472024 -4683 6 10.1509 6.49695 25.6483 14.6726 -6.33183 2.00995 -4684 4 9.37694 6.15153 26.0805 -12.3653 -8.75157 5.1154 -4685 4 9.82248 7.1865 25.0601 3.70088 -0.958502 2.30736 -4686 6 49.8668 7.2369 25.5225 -24.0329 9.97804 -6.35029 -4687 4 50.053 6.31696 25.3599 8.14544 -13.6468 -2.92498 -4688 4 50.6696 7.6642 25.7982 18.0374 4.82749 5.17198 -4689 6 18.4641 37.5693 33.932 -1.74635 9.46172 -1.89257 -4690 4 17.7617 38.2474 34.0853 10.1616 -18.2299 -3.47398 -4691 4 18.0542 36.6946 34.0238 -8.30855 4.53024 1.19921 -4692 6 32.1897 34.7964 39.2558 32.2313 -17.5381 13.0656 -4693 4 32.48 34.3381 40.0896 -7.23509 10.7133 -18.5379 -4694 4 31.2879 35.0284 39.3813 -31.6037 5.0658 8.82 -4695 6 49.5304 23.9104 4.45569 25.8701 3.67026 -38.321 -4696 4 49.7808 23.1947 5.01942 4.2809 -18.8946 17.0996 -4697 4 48.8132 24.3493 4.85794 -31.8244 16.1567 21.064 -4698 6 6.0606 24.4992 33.9345 -0.638471 -2.64646 7.7036 -4699 4 6.7001 23.7849 33.7997 2.17947 5.97399 -8.00372 -4700 4 5.47521 24.1274 34.6146 -0.567039 8.82042 -5.77933 -4701 6 1.71497 22.9937 24.1827 2.23241 21.1509 -1.27791 -4702 4 1.62302 23.9425 23.95 -0.486435 -10.8617 3.92094 -4703 4 0.825214 22.7289 24.4403 -5.44701 -4.12175 2.39318 -4704 6 12.4657 16.5565 32.3481 -44.3953 42.3465 -23.9812 -4705 4 13.2256 16.0186 32.4214 25.6927 -27.9273 24.4997 -4706 4 11.8347 16.6394 33.1026 23.5286 -12.3088 -0.369419 -4707 6 21.3722 37.3857 27.9432 8.33623 1.67622 30.3175 -4708 4 21.2745 37.3852 27.0022 -8.47587 6.30229 -26.1478 -4709 4 20.7646 38.0573 28.2974 0.343549 -1.37388 -6.67046 -4710 6 27.2371 40.835 28.8059 -14.5618 2.70883 26.0148 -4711 4 26.5104 41.4636 28.9519 7.17104 -1.72995 -14.6333 -4712 4 27.2442 40.3637 29.6524 5.83721 -3.62297 -8.28664 -4713 6 0.999535 21.7321 13.5318 -29.3194 4.17708 -0.571391 -4714 4 1.85706 21.6318 13.8745 50.1621 -4.04822 5.83187 -4715 4 0.493313 21.4968 14.3164 -12.4374 2.61082 -2.41507 -4716 6 22.3196 2.57547 8.74609 19.5097 -5.43411 17.7027 -4717 4 22.9517 3.10624 8.26305 13.4452 6.72454 -0.92593 -4718 4 21.5477 2.63817 8.2102 -22.9662 -0.14239 -10.9727 -4719 6 29.9886 17.8486 8.24374 -1.93571 4.49032 -2.67939 -4720 4 29.0601 17.6146 8.32603 -5.42798 -1.41354 1.1127 -4721 4 30.4131 17.4547 9.01282 4.29332 -3.23535 5.29369 -4722 6 3.62824 37.7086 25.7053 -21.3362 8.32154 -6.60892 -4723 4 4.42904 37.184 25.8405 -4.94962 -9.47676 -0.42012 -4724 4 2.83762 37.1591 25.4673 21.6133 3.65171 5.88982 -4725 6 26.7972 27.6476 36.3581 -47.4115 -5.5291 12.7506 -4726 4 26.8465 28.2624 35.6306 8.29087 8.74477 -10.4705 -4727 4 25.8218 27.6191 36.6005 30.1762 -0.597939 -6.56813 -4728 6 13.3509 25.3111 38.1214 6.90903 -15.9492 13.2692 -4729 4 13.3459 24.3911 38.4732 0.919555 17.3618 -5.73458 -4730 4 14.144 25.7168 38.5298 -8.43807 -1.25323 -5.48633 -4731 6 49.7161 27.2636 6.73274 -18.8339 5.2299 -32.7408 -4732 4 49.5935 26.3653 6.40806 5.58405 -0.645115 8.82912 -4733 4 49.2001 27.7791 6.04852 15.3529 -4.94049 26.886 -4734 6 39.7451 11.5811 10.2076 8.75523 -9.51322 -11.6408 -4735 4 40.371 10.9447 9.80262 -5.32314 14.1891 9.76509 -4736 4 39.1233 11.799 9.49079 2.50191 2.43793 7.76023 -4737 6 17.4883 24.9894 35.5591 -19.4762 1.01983 7.35275 -4738 4 17.0975 24.7887 34.694 2.72786 0.423626 1.28381 -4739 4 18.4353 24.8575 35.5073 10.004 -2.92602 -7.93295 -4740 6 45.0832 34.9807 31.8277 24.5651 -3.79623 6.38158 -4741 4 44.3095 35.5111 32.0501 -8.6141 -4.27399 -12.5931 -4742 4 44.9123 34.3632 31.1055 -12.5508 0.508806 -0.453023 -4743 6 30.2187 9.89463 31.3271 7.05348 4.55507 6.68413 -4744 4 30.4541 10.7656 30.9635 -3.12777 -8.04008 8.45875 -4745 4 30.1355 10.0083 32.293 1.90576 1.32601 -8.54322 -4746 6 32.3712 9.2149 6.61373 28.8381 -35.7198 -39.9492 -4747 4 32.1726 8.66567 5.78496 5.01502 20.0116 29.9298 -4748 4 31.5547 9.49954 6.96481 -36.3246 12.521 14.22 -4749 6 9.26959 24.9556 35.9161 1.96832 15.842 -17.2096 -4750 4 8.91298 25.4858 35.1726 -0.127744 -15.1166 11.0351 -4751 4 9.85583 25.5957 36.3463 -2.24606 -10.0757 2.02076 -4752 6 40.3298 1.49261 18.8755 10.6299 1.30292 -21.7 -4753 4 39.6194 1.80532 19.3944 -35.8146 17.5344 12.5449 -4754 4 40.7796 0.936194 19.4956 21.1502 -18.4862 6.40423 -4755 6 5.26901 10.6323 30.4328 -1.07618 -0.575959 25.8078 -4756 4 5.0059 11.4532 29.9824 1.00544 3.53991 6.4134 -4757 4 5.36238 10.8297 31.4225 -4.75078 2.46468 -31.0333 -4758 6 25.6472 11.7043 25.6564 -2.85241 -30.912 5.54365 -4759 4 25.9319 12.4737 26.1319 5.23872 14.1859 6.15637 -4760 4 25.9893 10.9537 26.204 -5.41829 19.961 -14.7301 -4761 6 21.91 20.0664 29.7913 -6.2328 1.4725 0.460556 -4762 4 22.5319 20.0532 30.5545 -13.0709 -9.05965 -9.53591 -4763 4 21.5487 19.1817 29.5606 11.8355 8.09924 7.60661 -4764 6 10.008 19.9919 34.5046 11.2891 -12.0839 -11.2138 -4765 4 9.40296 20.4589 35.0806 -5.60052 -0.834193 8.04722 -4766 4 10.0208 19.0442 34.745 -1.06298 11.667 -2.12072 -4767 6 24.6334 10.3662 12.209 5.25257 18.8662 20.0118 -4768 4 24.6941 9.47775 12.5956 1.57271 8.96717 -2.9517 -4769 4 24.9719 11.0034 12.9045 -11.2568 -27.0384 -15.8586 -4770 6 50.4496 28.283 11.5446 48.5969 7.21476 -25.6728 -4771 4 51.3012 28.7385 11.2434 -32.0883 -19.6524 11.3949 -4772 4 50.1145 28.8771 12.2081 -10.2548 6.02908 11.3498 -4773 6 13.9159 27.6234 25.0588 -25.6331 11.4059 -15.4978 -4774 4 13.5005 28.0493 25.83 5.93925 -3.01588 -8.8098 -4775 4 13.4276 28.0022 24.2718 14.6036 -12.4854 23.8457 -4776 6 46.1589 18.6653 40.4078 -23.2184 -0.389309 -10.7846 -4777 4 45.2349 18.5626 40.0761 15.1795 0.391647 5.46432 -4778 4 46.2048 19.5984 40.6658 -0.558864 -5.77386 -4.91212 -4779 6 32.4746 14.176 27.1227 -16.003 2.1806 5.505 -4780 4 31.9042 13.6172 27.6867 7.52463 5.83279 -7.70325 -4781 4 32.1655 15.0897 27.2802 4.78128 -6.53963 -2.41902 -4782 6 14.0556 36.3553 13.3828 19.8073 6.5728 22.6139 -4783 4 14.1017 37.3298 13.5875 -14.1879 -23.5484 -13.1576 -4784 4 13.3212 36.1206 12.8052 -8.41953 14.8686 -5.40295 -4785 6 1.88392 36.5802 21.9963 -4.52806 -9.18778 1.34501 -4786 4 1.78058 36.5165 22.9531 -3.13652 -1.22736 7.08711 -4787 4 2.81062 36.8013 21.8509 3.08344 1.49572 -0.20158 -4788 6 25.283 31.8665 39.7486 -0.0346121 -4.3463 21.3102 -4789 4 24.9491 32.7147 39.4474 -1.97702 6.83441 1.95234 -4790 4 25.5262 31.9404 40.7015 -5.12155 2.92558 -20.0537 -4791 6 6.47988 22.0137 1.28428 -12.6715 -7.61279 -4.66874 -4792 4 5.53909 21.8738 1.48571 10.6555 3.73696 2.93659 -4793 4 6.5727 22.8978 0.916948 1.0061 5.37498 -0.183021 -4794 6 27.6236 25.0404 4.70626 6.00578 18.2896 15.2827 -4795 4 28.5331 25.4118 4.61276 -17.9968 -6.47987 4.19831 -4796 4 27.2352 25.3966 5.54825 13.7859 -6.49357 -18.8943 -4797 6 21.6401 30.9371 41.2305 6.69834 21.9548 -27.1087 -4798 4 21.276 30.3289 41.855 -17.7491 -18.0709 13.8774 -4799 4 21.0024 31.0127 40.4783 8.64888 -5.56942 17.5854 -4800 6 32.355 18.8729 12.7674 13.4209 4.31066 2.75957 -4801 4 31.3956 18.9706 12.835 4.55688 -5.10905 -10.5867 -4802 4 32.607 18.5493 11.8826 -7.53687 3.28724 6.30822 -4803 6 35.6452 19.4617 21.1556 -9.82604 19.2175 8.60555 -4804 4 35.3405 18.5718 21.3708 -2.26659 -3.59924 -3.4629 -4805 4 34.936 20.0876 21.4701 16.8427 -19.1907 -7.36791 -4806 6 27.6904 17.9595 34.0135 2.51947 12.848 9.8691 -4807 4 28.1207 18.371 33.2456 -3.55582 0.0466306 5.59907 -4808 4 28.0719 18.4525 34.7708 -4.77519 -7.99763 -12.3529 -4809 6 34.1913 39.0308 14.8198 -32.2909 7.81486 42.3772 -4810 4 33.7378 38.3849 14.2709 2.40292 -0.641653 -5.60016 -4811 4 33.4938 39.1934 15.5434 31.6198 -1.67931 -26.5413 -4812 6 28.5078 3.47132 33.888 -4.80695 9.04662 2.15546 -4813 4 27.9441 4.2497 33.8725 -11.1427 -2.20885 -1.07295 -4814 4 29.3801 3.85895 33.8332 18.6007 -6.2612 -1.20104 -4815 6 34.9259 32.1312 6.54177 -41.0464 -12.9808 21.9467 -4816 4 34.0171 32.0297 6.98271 38.7419 4.2921 -24.6555 -4817 4 35.5211 32.1736 7.29951 5.76537 -1.35874 -3.25655 -4818 6 31.8896 6.8799 23.5232 0.89208 3.44668 5.58958 -4819 4 32.4231 6.58347 22.7679 -0.16899 1.4285 3.8543 -4820 4 32.2407 7.75715 23.7826 1.29066 -6.24882 -6.25814 -4821 6 18.8559 1.76458 0.828337 -20.5472 23.3683 -17.7838 -4822 4 18.0266 2.11952 0.42761 13.2396 -12.575 3.84382 -4823 4 19.0445 2.38904 1.53279 3.18086 -1.81057 9.578 -4824 6 26.9929 18.9294 11.856 68.8676 -4.65359 -28.5611 -4825 4 27.3133 19.7685 11.4551 -15.5879 -7.28987 7.59546 -4826 4 26.1136 18.988 12.1267 -55.7646 13.8464 15.3945 -4827 6 43.8351 11.1458 18.4443 23.0031 -19.5153 4.50837 -4828 4 43.638 10.8812 17.5537 -13.1544 4.18059 -17.1583 -4829 4 44.5589 10.5175 18.6246 -1.75483 13.9327 9.72942 -4830 6 33.4946 40.5615 37.6755 15.4013 8.76106 -9.33396 -4831 4 34.0096 40.2689 38.4502 -12.4229 -1.46966 -1.83753 -4832 4 32.5786 40.2698 37.7667 -1.95229 -4.85928 9.55413 -4833 6 15.6186 26.7023 39.419 -29.2453 -49.1617 7.39509 -4834 4 15.4971 26.9949 40.3155 1.17426 12.5786 14.7177 -4835 4 16.1446 27.3092 38.9602 29.5915 33.502 -22.8309 -4836 6 4.38071 13.8775 40.883 9.27553 -14.126 -4.37485 -4837 4 5.31782 13.6454 41.0342 -11.8393 4.50398 0.960258 -4838 4 4.04834 13.2497 40.2173 2.13772 10.7877 7.68198 -4839 6 20.1656 10.4005 38.218 10.8779 4.82467 -13.4554 -4840 4 20.4848 10.7245 37.3555 -10.2589 -5.36296 0.708096 -4841 4 20.9923 10.2607 38.6798 -1.28838 -2.71386 11.844 -4842 6 15.1666 19.24 23.8849 4.49083 -8.21488 3.46045 -4843 4 15.3253 20.1347 24.2296 -1.0797 -1.90309 -4.08137 -4844 4 15.0239 19.3391 22.9299 0.969961 5.53483 11.956 -4845 6 47.8934 28.614 15.7995 12.3109 16.1315 8.54118 -4846 4 47.9523 27.7003 15.5425 0.10403 -15.196 -3.00888 -4847 4 48.6265 28.752 16.4246 -6.57835 -5.21115 -6.70139 -4848 6 29.9259 30.9075 18.965 7.62461 4.23841 -1.37457 -4849 4 29.1117 30.4308 18.7732 -7.06282 -5.88302 -2.4339 -4850 4 29.7134 31.8391 18.8515 -2.57834 1.4724 1.74445 -4851 6 11.9338 35.8178 28.497 -7.27451 6.14295 -10.3733 -4852 4 12.5041 35.9802 29.2427 6.70347 11.4983 16.16 -4853 4 12.1847 34.9375 28.2428 -3.53576 -18.0038 -9.26428 -4854 6 29.972 37.8772 25.486 -12.1052 4.73031 -22.3992 -4855 4 30.2553 36.9663 25.6711 3.40868 8.54106 4.83275 -4856 4 30.3747 38.5051 26.0898 8.03536 -1.45294 10.6494 -4857 6 52.6584 28.1048 32.275 31.4311 4.91254 4.04956 -4858 4 52.2473 28.8547 31.8392 -9.38068 2.35947 -3.12986 -4859 4 53.5924 28.4001 32.3224 -6.05351 -9.99886 1.81474 -4860 6 37.0156 40.0823 11.982 15.2095 -8.99172 -8.52195 -4861 4 36.22 40.5624 12.1833 -15.2617 4.79593 6.40041 -4862 4 37.4101 39.8767 12.8402 0.665617 -0.484924 4.09883 -4863 6 16.6662 16.7824 36.4899 -23.6543 20.4081 -13.3107 -4864 4 16.0299 17.4889 36.7962 20.061 -22.8424 -10.9222 -4865 4 16.728 16.9177 35.5139 -3.3638 -0.555369 18.7216 -4866 6 27.9984 4.17668 38.8431 -6.8633 -1.77316 4.22536 -4867 4 28.9161 4.3061 39.1095 4.06977 1.67187 2.70396 -4868 4 28.0368 3.69267 38.0106 -3.95018 -5.40445 -5.6405 -4869 6 28.9057 0.266004 17.7212 -6.10073 29.2375 -5.44551 -4870 4 28.1786 0.88303 17.5246 8.92385 1.95552 -1.67076 -4871 4 28.4447 41.3635 17.8399 -11.0591 -30.1495 5.35559 -4872 6 22.9291 20.1009 26.2737 12.905 2.01461 18.3128 -4873 4 23.6265 20.0378 26.9508 -1.05622 -6.52034 -10.1156 -4874 4 22.4706 20.8929 26.5742 -3.00423 3.39878 -4.61403 -4875 6 49.3993 29.9017 13.433 -6.38025 27.1117 -0.919919 -4876 4 49.1201 30.8275 13.1802 1.84527 -26.9682 8.98406 -4877 4 48.7504 29.5045 14.041 1.51099 8.43883 -0.914593 -4878 6 2.44855 24.8301 7.30401 -10.5471 2.4163 20.698 -4879 4 2.41495 24.6588 8.2845 -1.1432 9.4633 -23.8545 -4880 4 1.72338 25.455 7.1058 6.30785 -9.44609 7.39061 -4881 6 30.3915 26.4508 14.3344 -6.38639 41.9339 41.7386 -4882 4 31.0669 26.3804 15.0403 -0.162406 -14.5956 -15.076 -4883 4 29.932 27.2875 14.6522 8.5071 -34.3491 -22.1885 -4884 6 27.0361 32.5047 3.13805 -13.013 14.5566 5.91638 -4885 4 26.4776 33.1542 3.63465 13.8957 -14.3888 -12.6314 -4886 4 27.3381 31.8882 3.81715 0.997102 -1.94867 -0.811892 -4887 6 34.2693 14.8073 1.28197 14.9869 -24.9335 -24.2287 -4888 4 35.1732 14.4308 1.1613 -12.3133 12.1546 9.27146 -4889 4 33.7818 14.2606 0.617478 5.51233 18.0169 18.4334 -4890 6 30.0243 8.54272 1.33127 -15.3984 1.11418 15.9731 -4891 4 29.9557 9.47917 1.12547 1.89625 5.05184 -1.94546 -4892 4 29.278 8.4251 1.95594 13.4411 -5.55834 -8.66406 -4893 6 42.5535 11.5155 27.7085 15.437 -3.44919 -13.726 -4894 4 42.3225 12.4337 27.8881 -6.79772 -1.02898 5.45325 -4895 4 41.899 10.9203 28.077 -14.0379 1.06089 7.70623 -4896 6 52.4658 39.5603 17.8381 6.64956 -28.6351 -32.0971 -4897 4 51.7413 39.7621 18.3991 -22.9429 13.2738 25.1291 -4898 4 53.1708 40.1592 17.9962 19.9289 22.995 10.0024 -4899 6 33.211 4.92827 31.629 -12.2211 32.167 9.39859 -4900 4 32.8163 5.83971 31.6275 7.84415 -21.2817 2.59476 -4901 4 32.9135 4.52627 30.8083 -0.68235 -2.18314 -5.10952 -4902 6 6.29493 15.9859 18.7482 13.6791 10.985 9.78561 -4903 4 5.93033 16.6016 19.4273 2.88753 -17.718 -13.1605 -4904 4 5.60754 15.3724 18.4768 -10.6912 0.909102 4.08099 -4905 6 8.51749 14.5386 24.6879 -5.02573 1.07483 -2.93277 -4906 4 9.38168 14.4087 25.0828 4.4136 1.3116 3.34168 -4907 4 8.20169 13.6557 24.4566 1.37146 0.850768 1.15416 -4908 6 22.6856 10.1159 32.1347 3.63858 -5.5341 -7.29103 -4909 4 22.4401 11.0127 32.2731 -27.0162 20.0988 15.0061 -4910 4 23.4682 10.3148 31.6383 25.2173 -15.197 -13.8617 -4911 6 11.2884 2.11431 14.6724 -33.0968 -7.95794 -19.898 -4912 4 10.3134 2.08073 14.4479 21.8664 -1.34414 10.3974 -4913 4 11.7152 2.30811 13.8211 9.70644 2.30495 0.939267 -4914 6 44.9099 15.5878 36.2745 25.7257 2.41581 -13.4012 -4915 4 45.0546 15.5553 35.3019 -10.2235 2.9059 20.3658 -4916 4 43.9848 15.4747 36.4307 -17.7944 -2.84066 -0.111047 -4917 6 9.72168 19.0116 31.2214 10.0341 -21.2505 -12.9994 -4918 4 10.5925 19.389 31.3727 0.996524 0.534629 3.32861 -4919 4 9.08651 19.5363 31.6795 -15.0033 12.5653 12.9482 -4920 6 51.9861 7.59179 16.6767 -2.21949 13.5197 0.492591 -4921 4 52.6037 6.8327 16.6765 -16.3843 6.63384 -16.8766 -4922 4 51.5083 7.75362 15.8118 21.6515 -16.4571 17.7861 -4923 6 31.4364 34.7816 36.4086 3.08769 21.0155 -3.2672 -4924 4 31.7704 34.8477 37.2975 8.82098 -13.2304 13.8104 -4925 4 31.3443 35.7177 36.1951 -3.32863 3.82124 -15.3061 -4926 6 4.22848 15.0876 15.3675 -15.1793 -4.71932 15.5862 -4927 4 4.10446 14.9036 16.3273 5.02277 2.80423 -15.2934 -4928 4 5.16622 15.2495 15.2447 10.6913 1.67801 0.337818 -4929 6 47.7535 20.6847 28.0297 3.73811 3.24498 -1.95167 -4930 4 47.6703 19.7739 27.6852 3.21079 12.9013 3.0329 -4931 4 48.3469 21.1738 27.4217 -9.1514 -8.95746 6.26441 -4932 6 15.7983 1.14885 24.4111 -6.64534 16.957 -16.446 -4933 4 15.3695 0.397874 24.8496 -11.2605 5.13601 -9.62176 -4934 4 15.1572 1.72115 23.8957 14.1067 -25.56 23.4483 -4935 6 34.5718 39.7067 40.0668 -5.06722 14.7699 1.92827 -4936 4 34.1159 40.1215 40.7935 -0.0189783 27.8984 7.01187 -4937 4 34.2456 38.8495 40.221 -5.22714 -44.7262 -10.8544 -4938 6 20.1936 32.176 34.4055 -22.5016 27.7868 41.3602 -4939 4 19.6673 32.7687 35.0502 14.2298 -29.0143 -30.198 -4940 4 21.0584 32.1328 34.8407 -2.28869 -2.39527 -4.5293 -4941 6 19.3074 38.5208 11.8317 17.689 14.4135 -2.63233 -4942 4 19.236 37.5914 12.0232 -0.177798 -10.0936 4.99209 -4943 4 20.0172 38.8749 12.4245 -13.7536 -7.85063 -8.99287 -4944 6 6.52955 13.5023 26.836 -16.6143 37.6784 -17.6139 -4945 4 6.084 14.0762 26.1427 18.8957 -21.2062 24.9102 -4946 4 6.49663 12.6281 26.4634 0.197125 -15.4908 -4.14034 -4947 6 23.5952 31.5638 33.3318 1.16311 -12.5666 -5.83621 -4948 4 23.0836 31.562 34.1475 0.610672 3.97154 0.891929 -4949 4 23.5328 30.6432 33.0053 1.46337 8.27478 -1.79938 -4950 6 41.0778 31.9114 16.1974 16.3032 -14.6541 -18.8682 -4951 4 41.8878 32.072 16.7344 -12.1593 -9.44827 -16.6375 -4952 4 41.2894 31.3264 15.4036 6.53327 16.9697 25.199 -4953 6 31.7476 18.8699 19.3483 9.2825 22.1595 5.37598 -4954 4 32.0642 19.7361 19.7036 -9.20895 -19.367 -8.68372 -4955 4 31.4026 18.3831 20.1168 1.10858 -0.37958 -4.48043 -4956 6 10.4875 4.12209 19.3444 6.70816 11.4672 -10.0773 -4957 4 9.70261 4.48263 18.8666 20.7562 -4.21822 -0.723312 -4958 4 11.3166 4.33216 18.8218 -27.5212 -3.06207 15.0001 -4959 6 1.37991 32.4635 19.2846 24.7257 -29.6508 -15.3303 -4960 4 1.97113 31.6954 19.1311 -3.90248 7.07021 19.3035 -4961 4 1.16609 32.6455 18.3731 -9.24935 13.5936 -9.63824 -4962 6 42.8716 16.8513 24.9892 37.8526 -21.8211 -51.5646 -4963 4 42.4398 17.6894 25.0051 -12.6784 17.6471 3.13223 -4964 4 43.4179 16.871 24.1222 -26.4831 0.994324 39.976 -4965 6 45.3183 19.1979 4.10041 6.37956 15.045 3.35342 -4966 4 46.1127 19.7887 4.04575 -15.2131 -7.48775 2.85843 -4967 4 44.6191 19.6898 4.58798 10.0124 -1.75765 -5.61527 -4968 6 29.1291 19.8804 35.7574 13.154 -41.1853 -12.3735 -4969 4 28.6049 20.2559 36.4387 -19.4183 16.2678 16.1743 -4970 4 29.3151 20.5439 35.0927 -1.78114 11.3903 -2.63997 -4971 6 31.9353 21.8377 19.6787 8.2762 14.7684 -3.54893 -4972 4 32.7301 21.8918 19.0885 -22.5823 -4.29925 15.9785 -4973 4 31.6692 22.7774 19.8195 3.83825 -20.8185 -1.08359 -4974 6 39.1936 8.26228 18.8336 -23.7578 16.4079 -2.4793 -4975 4 38.9784 7.343 18.63 -1.41923 -3.63173 -0.882922 -4976 4 38.3593 8.77699 18.6285 24.7505 -17.6369 4.60834 -4977 6 33.27 13.2649 41.2621 -10.1289 -28.0457 11.6457 -4978 4 32.3532 13.5818 41.1472 2.43324 -1.71459 -0.314725 -4979 4 33.2053 12.355 41.6729 1.3348 20.3333 -9.56947 -4980 6 5.93721 29.5458 35.7995 -7.4397 -15.3695 -5.23966 -4981 4 6.3797 30.3135 36.1022 6.42857 23.5026 12.0451 -4982 4 6.51225 29.246 35.0987 1.02237 -6.8727 -9.18458 -4983 6 13.023 34.1764 31.9266 -10.1581 -4.84889 27.419 -4984 4 13.003 33.3874 31.3637 -4.82745 -5.23795 6.11925 -4985 4 12.6053 33.9771 32.8123 10.4055 -1.49763 -26.3146 -4986 6 33.9757 21.8032 17.9969 16.1152 -19.1834 -4.43927 -4987 4 34.6651 21.0941 18.0436 -13.0194 10.1005 -1.31384 -4988 4 34.4424 22.6001 17.7557 11.611 10.6919 -5.33679 -4989 6 35.9777 41.3398 18.1614 -6.56463 -6.11943 -26.9477 -4990 4 35.8856 41.423 17.1648 6.35377 -3.40276 32.4743 -4991 4 36.5823 0.128109 18.4064 3.22136 6.47441 1.04719 -4992 6 34.856 37.6452 30.5972 -0.647303 3.94572 7.36538 -4993 4 35.2577 36.9607 30.0196 0.445186 1.06156 15.4535 -4994 4 34.8848 37.3986 31.5588 5.49281 -5.52744 -23.9922 -4995 6 25.9972 34.4216 4.68589 -10.7784 -9.94602 -21.2075 -4996 4 25.3582 34.53 5.39473 2.66172 5.48603 12.8385 -4997 4 26.8259 34.8497 4.89674 4.47855 8.12742 13.9663 -4998 6 19.0606 33.5662 1.31783 4.31184 23.0948 -29.5486 -4999 4 19.7493 33.0549 1.74461 7.17592 -5.61608 3.87291 -5000 4 19.5019 34.1007 0.592753 -8.94353 -18.7796 23.9626 -5001 6 25.2721 8.22916 8.60038 8.3672 -6.50911 13.4278 -5002 4 25.4774 8.1828 9.55838 -2.37789 7.03817 -10.0574 -5003 4 25.4001 9.14285 8.30246 -0.229164 -0.61302 1.82749 -5004 6 12.8408 19.6874 13.0432 23.1779 -10.767 -3.57874 -5005 4 11.9236 19.9359 13.0109 -16.1394 8.08564 -1.3752 -5006 4 13.3549 20.4875 12.8299 -11.6819 -5.55115 1.76181 -5007 6 53.3458 11.4322 5.81729 13.7919 -26.0181 10.511 -5008 4 53.941 11.999 6.3288 -5.2171 7.54934 -1.97002 -5009 4 52.6156 11.905 5.44666 -11.025 16.6744 -4.72885 -5010 6 9.84401 16.0447 31.1965 1.52473 25.7097 1.4485 -5011 4 9.0725 15.75 30.7245 -12.2986 -10.5074 -10.4763 -5012 4 9.76401 17.0228 31.1974 4.09395 -10.8484 3.46066 -5013 6 25.4337 20.2897 3.31222 -0.0744965 -16.6885 15.2888 -5014 4 25.4502 20.7681 4.1742 1.29774 3.58896 -22.0188 -5015 4 25.617 20.9088 2.59036 0.892976 4.59184 10.0233 -5016 6 20.7687 8.19442 15.6442 -13.8219 -45.5838 -0.24202 -5017 4 20.3131 8.5145 16.4113 -6.16339 18.6345 13.1662 -5018 4 20.3525 7.29833 15.5772 17.5129 18.5489 -8.91575 -5019 6 37.6537 8.61162 9.99803 6.38032 -10.5281 17.8344 -5020 4 37.9174 7.70722 10.2264 -2.01487 8.44182 4.78342 -5021 4 37.3414 8.51532 9.10193 -3.86116 3.7435 -6.65528 -5022 6 50.6588 4.51187 24.2729 -10.1552 -3.70856 6.87258 -5023 4 49.9071 3.88527 24.1971 13.583 4.61791 0.248303 -5024 4 51.4381 4.036 24.5943 -3.42543 -3.47462 2.6777 -5025 6 20.1632 24.8244 34.8962 -12.0105 28.899 -22.2545 -5026 4 19.9486 25.4522 34.1467 5.29317 -18.0262 19.0072 -5027 4 20.331 23.9626 34.5117 -0.31696 -10.3492 -2.27521 -5028 6 30.5785 22.522 11.2467 -2.76969 13.8933 23.9619 -5029 4 31.2526 22.1243 10.7257 13.2932 -13.8734 -17.1472 -5030 4 31.019 23.338 11.5119 -11.6942 5.7798 2.38886 -5031 6 17.322 40.803 8.03266 14.2969 -15.2802 9.14469 -5032 4 17.3696 39.9923 8.55945 -20.3131 5.85274 7.92005 -5033 4 18.1352 40.6655 7.5489 4.4024 9.10004 -19.1526 -5034 6 23.9661 41.0457 26.0803 21.1205 -0.428792 10.5169 -5035 4 24.3123 40.6207 25.2948 17.4674 -5.32369 -4.96192 -5036 4 23.0464 41.0448 25.8953 -36.0489 4.67224 4.09659 -5037 6 9.79449 25.5813 27.216 11.7002 -20.4303 -20.1428 -5038 4 10.1564 25.0129 26.491 -8.57195 17.3601 17.171 -5039 4 10.1924 25.2359 28.0288 -3.53182 0.239058 0.558234 -5040 6 35.2535 29.8267 24.7533 16.8399 6.514 6.92542 -5041 4 34.3962 29.6585 24.3475 -6.29365 6.70405 -5.90439 -5042 4 35.51 30.7547 24.57 -10.2352 -8.20594 -2.77553 -5043 6 2.14051 4.25227 10.5512 -4.35014 2.09559 7.87868 -5044 4 1.87018 4.24401 11.51 4.03105 2.56783 -22.6964 -5045 4 1.48695 4.75313 10.0317 0.0426026 -1.98947 12.7879 -5046 6 43.1755 3.92129 23.5016 -16.6861 -14.9885 0.818311 -5047 4 43.8939 4.14262 22.9078 7.68421 2.83398 -7.81803 -5048 4 42.5577 3.34913 22.9937 11.3891 7.34243 2.48813 -5049 6 18.8996 22.6297 2.43765 22.7339 -13.1014 -2.24121 -5050 4 19.79 22.181 2.40524 -25.7911 11.1615 4.63986 -5051 4 18.7139 22.8085 3.37028 4.18935 -2.21949 -1.21374 -5052 6 20.4908 18.9405 41.5599 0.284845 -17.4141 21.8797 -5053 4 20.1374 18.6064 0.533469 2.69626 22.1818 -33.2143 -5054 4 19.9839 19.6587 41.147 -4.56676 -6.01516 12.1125 -5055 6 26.4163 7.55623 29.1338 1.47231 -3.25042 -11.8229 -5056 4 25.7099 7.08251 28.6481 8.40182 7.03804 13.9135 -5057 4 27.0821 7.71224 28.4448 -4.02075 -2.1597 11.7889 -5058 6 25.6465 35.5679 33.7595 -11.9902 -19.4032 2.16293 -5059 4 26.3374 36.2384 33.6103 2.60319 -14.9989 -6.30077 -5060 4 25.8315 34.6987 33.2841 2.54327 33.8846 12.2934 -5061 6 24.8333 0.493635 8.41989 34.5336 11.5552 47.2955 -5062 4 25.5249 0.302877 9.1499 -35.8013 6.01564 -39.2036 -5063 4 24.7614 41.6068 7.91956 0.436288 -16.6888 -13.1367 -5064 6 17.008 17.3182 3.45493 -26.2706 15.7324 15.4846 -5065 4 16.2426 17.9829 3.53843 29.8189 -30.5055 4.13684 -5066 4 17.1653 16.9244 4.35506 -11.2277 16.1793 -19.3505 -5067 6 40.1827 32.1035 19.3506 13.0539 -5.95213 0.358733 -5068 4 39.8335 31.2604 19.604 -25.4023 -11.2285 12.0125 -5069 4 40.9513 31.7409 18.9215 18.5667 14.352 -9.19942 -5070 6 23.3808 26.7171 6.31746 29.0762 21.4976 14.3842 -5071 4 24.13 27.3908 6.46801 -30.1018 -19.5893 -7.69607 -5072 4 22.7349 27.0723 5.68536 3.11778 6.18165 -0.6273 -5073 6 28.6527 28.5112 1.41186 -10.6623 -30.4119 4.69741 -5074 4 28.683 29.4458 1.20631 15.125 4.74584 -7.70298 -5075 4 29.5288 28.0803 1.2704 -12.115 26.7011 1.44139 -5076 6 12.0438 6.3157 14.0384 -8.70244 -3.06108 -4.52058 -5077 4 11.2798 6.1721 13.4181 27.4537 -0.215786 8.28745 -5078 4 12.8925 6.19521 13.5554 -16.057 2.9292 1.41242 -5079 6 20.1243 33.7022 32.0954 -30.4257 7.53408 -8.19993 -5080 4 20.1371 33.1054 32.8412 7.6416 -5.80656 10.7415 -5081 4 21.0197 33.8732 31.8382 18.9224 -1.8204 -0.321518 -5082 6 12.0625 33.3632 34.5388 -0.325915 -41.4281 -23.9157 -5083 4 11.5602 33.8727 35.1697 -10.674 0.646784 10.687 -5084 4 11.6234 32.4653 34.3673 14.5179 34.5198 8.14895 -5085 6 6.00279 22.2605 25.0501 2.06163 -11.5991 79.3474 -5086 4 5.88194 22.3996 24.153 -16.4068 14.8809 -57.8418 -5087 4 5.25089 22.6367 25.5854 16.5977 -6.05374 -22.2773 -5088 6 28.8802 9.48792 11.0269 30.0757 -27.8021 5.60101 -5089 4 29.142 10.167 11.6644 -15.2392 1.2069 -12.766 -5090 4 28.0854 9.70897 10.5587 -15.7703 15.13 -3.00542 -5091 6 25.9783 31.1564 24.8742 0.212243 -23.2246 11.0271 -5092 4 26.2703 31.9474 24.4305 5.78101 9.73635 -10.8861 -5093 4 26.5948 30.4205 24.6499 -9.08002 14.2421 1.82694 -5094 6 17.4069 22.6321 26.9528 -11.8732 29.0046 13.506 -5095 4 17.1509 23.4374 27.5137 11.798 -28.7792 -23.9739 -5096 4 17.5283 21.9112 27.5803 0.671776 -8.09241 2.21186 -5097 6 30.9731 17.6144 1.64569 13.582 26.8251 31.1357 -5098 4 30.2123 17.6859 1.07719 -13.0538 -2.75682 -13.3747 -5099 4 31.0067 18.4528 2.19078 1.05257 -25.2161 -14.5596 -5100 6 35.2833 9.73343 11.2271 -16.277 -4.62114 -26.0747 -5101 4 34.627 9.45499 10.5137 29.3374 5.62349 25.4867 -5102 4 36.1567 9.37366 10.9701 -6.28276 0.375521 -3.01301 -5103 6 12.0057 10.8077 4.27601 -12.2512 -1.40581 -7.43609 -5104 4 11.4458 10.5898 5.05281 2.39288 0.24657 -15.6405 -5105 4 11.51 10.5288 3.46435 7.55978 2.35404 20.8087 -5106 6 52.9546 23.1284 7.66438 3.19212 11.9041 -9.13647 -5107 4 53.8155 23.0936 7.22037 1.72331 -6.21969 -0.472682 -5108 4 52.7997 24.0739 7.82392 -0.633169 -8.94194 3.43433 -5109 6 27.374 5.80114 23.1096 7.51778 12.7335 11.6917 -5110 4 28.1753 5.52132 23.6349 -22.415 18.9583 -13.4562 -5111 4 27.3645 6.79042 22.9959 5.3793 -33.2455 5.89418 -5112 6 22.7689 37.6996 15.5372 -5.91943 -7.67105 33.7333 -5113 4 22.8436 37.842 14.6084 2.14719 5.97904 -25.5056 -5114 4 23.2999 36.9284 15.7907 -0.822855 1.46565 -2.93441 -5115 6 30.5901 30.1355 39.7465 -8.92084 9.99629 -19.6672 -5116 4 30.0839 29.6315 39.0953 -1.54922 -9.94816 6.16305 -5117 4 30.5761 31.0154 39.3281 8.00114 -4.73058 9.29019 -5118 6 26.5152 14.8694 29.9646 3.93344 -0.205179 -3.29595 -5119 4 25.7559 15.3094 30.3103 -24.5604 12.1261 -1.41502 -5120 4 27.0839 14.9289 30.718 22.1413 -5.57177 12.178 -5121 6 9.52543 19.5487 37.4182 -4.93509 -3.75546 7.04348 -5122 4 8.56858 19.5373 37.6772 20.7537 10.8584 -9.00922 -5123 4 9.7741 20.4052 37.0166 -14.5013 -9.56436 9.93265 -5124 6 0.91928 14.8658 2.69601 -17.5095 9.99019 63.3715 -5125 4 1.47581 15.1737 2.02419 28.2707 8.36374 -43.6031 -5126 4 1.18821 15.4309 3.47389 -7.04008 -21.0896 -18.5042 -5127 6 46.427 27.1287 41.5945 43.2461 -1.33556 -25.8044 -5128 4 47.402 27.2052 41.2817 -46.4011 -2.64418 15.4668 -5129 4 46.0299 26.5803 40.8989 0.996959 5.24299 8.87294 -5130 6 47.678 23.0562 21.3872 5.44089 38.3346 6.01366 -5131 4 46.9403 23.2179 20.8133 -13.997 9.90145 -6.64011 -5132 4 47.7418 22.1285 21.385 8.56341 -43.7487 4.99103 -5133 6 39.8587 22.235 3.08723 2.37939 -15.5871 -9.21378 -5134 4 39.0088 22.2526 3.53641 -4.44104 7.43329 4.08383 -5135 4 39.9535 21.2857 2.86173 -0.917299 22.2801 6.61021 -5136 6 14.9853 14.9328 33.4647 9.90785 18.6887 5.96998 -5137 4 15.4024 15.8269 33.5858 -13.0369 -24.3412 -0.758701 -5138 4 14.5599 14.6915 34.3048 3.28451 6.61064 -6.43534 -5139 6 27.3302 11.4834 31.9317 -27.4366 -15.9755 21.8219 -5140 4 26.9982 12.0952 32.5883 -9.79098 -5.70708 8.51591 -5141 4 28.0752 11.9422 31.6406 46.9031 18.536 -28.2392 -5142 6 36.7579 7.97089 7.62034 -1.24967 -18.9477 -14.6485 -5143 4 35.954 7.42009 7.70022 6.4697 6.94413 -3.0671 -5144 4 37.4142 7.36122 7.22008 -3.07725 6.9494 1.66736 -5145 6 49.4451 9.66335 18.2174 -4.20907 -17.0946 -5.32386 -5146 4 50.1075 10.0642 17.6138 -11.2883 10.4151 20.0604 -5147 4 49.0937 10.2089 18.9473 16.8995 10.9543 -13.1485 -5148 6 27.0353 33.866 10.7555 -3.61813 20.4819 39.0174 -5149 4 27.1089 33.3944 9.9425 -11.0368 -7.55411 -28.9907 -5150 4 26.1735 34.332 10.8422 4.28798 -12.7598 -13.2634 -5151 6 11.1949 37.4624 6.84871 0.36549 -16.8746 15.3404 -5152 4 10.8648 38.3395 6.66289 0.465253 11.7734 -2.90488 -5153 4 12.1583 37.5341 6.85599 1.64848 0.115814 -1.2743 -5154 6 19.2537 19.4156 21.9114 -15.7985 8.22585 33.6704 -5155 4 18.5515 19.3251 21.2863 -16.3583 -5.26309 -15.3133 -5156 4 20.0646 19.323 21.4355 25.7859 -3.53787 -14.4318 -5157 6 54.4972 2.91444 22.5674 41.6328 11.7794 25.4635 -5158 4 54.323 3.09449 21.6644 -16.7292 4.15243 -34.296 -5159 4 0.405558 3.31869 22.7045 -24.6299 -12.807 4.19326 -5160 6 45.0583 10.8549 24.2301 5.83399 20.0221 21.0618 -5161 4 44.4296 11.5751 24.1426 -7.03973 -3.51443 -9.4179 -5162 4 45.6095 11.2138 24.9523 4.1225 -19.1196 -10.3672 -5163 6 14.387 34.402 24.7643 -0.614961 -5.50567 -8.46915 -5164 4 14.802 35.2302 25.0278 -0.621724 2.17228 4.67692 -5165 4 14.8142 34.1913 23.9221 -0.527667 -3.77388 -2.27373 -5166 6 50.586 17.557 4.30707 17.1275 -18.9627 18.6811 -5167 4 51.3126 17.9927 4.759 8.45418 -3.82203 7.11351 -5168 4 50.1863 18.2804 3.88376 -26.598 27.5468 -24.7799 -5169 6 14.9317 33.3337 34.1113 -12.3404 20.8418 56.9019 -5170 4 15.0455 32.9404 33.2912 5.44957 -23.8922 -53.334 -5171 4 14.0148 33.1563 34.3942 8.12215 6.97131 -5.23034 -5172 6 20.8706 33.5768 38.9143 15.1188 7.04694 -15.6549 -5173 4 20.7999 34.008 39.7578 -2.44584 7.66125 17.1111 -5174 4 20.3826 32.7659 38.9944 -10.1095 -18.4284 -0.973943 -5175 6 7.78494 4.73961 26.7587 18.7098 -5.63937 13.378 -5176 4 7.2181 5.0845 27.4506 -5.7435 6.37459 2.19378 -5177 4 7.246 4.75931 25.9687 -5.82922 -1.99593 -5.70414 -5178 6 9.28281 21.4851 22.3014 51.087 14.0475 -25.6174 -5179 4 8.74732 21.9732 21.6886 -31.0609 5.1079 -5.58489 -5180 4 10.1706 21.7227 21.8793 -22.1752 -18.3044 28.8298 -5181 6 20.5441 38.2146 8.8638 -2.83914 11.917 26.817 -5182 4 20.3663 38.6401 9.7626 4.81036 -21.6973 -30.7816 -5183 4 20.4013 37.2533 8.94236 -1.07384 9.24152 7.62946 -5184 6 30.1053 39.0795 30.7451 -13.6764 41.2724 28.6819 -5185 4 30.3998 39.946 31.2193 -9.10868 -42.8123 -24.766 -5186 4 29.1169 39.0706 30.8728 28.3121 -0.882933 -5.94109 -5187 6 16.0486 22.0268 24.5039 34.2787 3.60452 0.906339 -5188 4 16.7735 22.0671 23.8432 -14.3833 -3.87047 -0.289875 -5189 4 16.5419 22.3002 25.3044 -14.2176 -3.36187 3.5873 -5190 6 5.74232 29.2062 14.4594 -18.34 10.8061 -32.1404 -5191 4 6.48422 28.7094 14.7814 11.5218 -3.49899 17.506 -5192 4 5.24211 29.6259 15.1721 5.10135 -5.91064 9.04276 -5193 6 28.0673 3.08827 25.2267 -6.08854 1.42804 12.0746 -5194 4 28.6661 3.71086 24.7756 -7.19123 -0.840207 10.3279 -5195 4 27.7106 3.5203 26.0449 13.0908 -0.523763 -20.3567 -5196 6 45.9319 29.2971 31.4223 -7.33073 21.7818 28.5056 -5197 4 45.7264 28.738 30.6765 -12.0419 -4.51403 -16.7723 -5198 4 45.1872 29.9464 31.611 20.2512 -24.9239 -13.0948 -5199 6 11.2178 22.8398 36.7928 3.83605 7.6889 -19.1741 -5200 4 10.7288 23.4227 36.1801 1.54849 -6.36416 6.79315 -5201 4 12.0227 22.5824 36.3 -5.92076 -0.954096 11.0422 -5202 6 18.9236 40.1387 39.9284 -8.72712 -15.4473 12.674 -5203 4 19.137 39.1923 39.9727 -1.01676 1.76774 -7.47997 -5204 4 18.926 40.4024 40.8597 -1.95632 5.76083 -1.10583 -5205 6 23.5567 26.0801 21.2876 -20.8354 -5.58511 20.4095 -5206 4 22.8283 26.6117 20.9473 7.44123 1.31497 -7.03875 -5207 4 23.1869 25.6705 22.0991 12.7429 3.57595 -14.6326 -5208 6 16.8309 5.38685 15.8596 17.5735 -24.6285 20.3591 -5209 4 16.4468 5.29371 14.9868 -10.6119 14.9975 -0.930521 -5210 4 16.6163 6.1995 16.3389 -7.69088 7.65746 -13.895 -5211 6 12.049 26.6129 14.9962 1.83385 5.07399 -16.0821 -5212 4 11.6864 25.936 15.5307 6.55853 -24.3886 27.1256 -5213 4 11.2609 26.839 14.5085 -0.894459 16.8406 -16.785 -5214 6 14.3334 41.4222 2.37421 26.0216 21.5484 -18.2857 -5215 4 13.7051 40.9662 2.90199 -22.7144 -12.1023 21.977 -5216 4 14.3738 0.426145 2.71152 -4.41702 -11.6567 2.07407 -5217 6 50.4009 35.8582 9.31454 24.1561 17.2373 -12.1424 -5218 4 50.8168 35.8748 8.42953 -10.1576 -5.67977 3.83986 -5219 4 50.8977 36.5714 9.7704 -11.7974 -14.2445 3.10197 -5220 6 11.3695 22.6672 26.8678 6.20997 3.92483 11.2558 -5221 4 12.2048 22.3333 26.5164 -4.88328 -1.76893 -0.685046 -5222 4 10.6892 22.391 26.2565 -8.40373 -4.36232 -8.95219 -5223 6 8.45148 34.5593 21.2814 -25.9919 -59.0281 13.1791 -5224 4 8.04792 35.0446 21.9998 -0.548909 12.0582 7.93151 -5225 4 8.02348 33.6171 21.3881 27.3669 48.26 -12.6189 -5226 6 9.41918 8.68911 24.4735 -32.1109 22.232 -11.1027 -5227 4 8.45415 8.80658 24.2608 22.5553 -3.45738 3.03744 -5228 4 9.54271 9.26889 25.2379 6.1219 4.18012 4.13063 -5229 6 32.6166 22.3351 34.507 3.90791 9.0503 -27.7323 -5230 4 32.5036 23.1955 34.0662 0.599489 -5.17288 -1.28756 -5231 4 32.8196 22.6091 35.3861 6.87298 3.84758 30.2519 -5232 6 26.7427 26.1702 7.11338 18.0622 8.0778 -11.4877 -5233 4 26.0574 25.7087 7.60312 -9.51312 -3.43645 7.19196 -5234 4 26.4504 27.0916 6.97179 -2.60416 -16.0173 4.37043 -5235 6 33.9976 11.9299 3.97475 -1.16308 1.75568 6.69865 -5236 4 33.7915 11.6388 4.87314 3.4696 4.99202 0.68255 -5237 4 33.8545 12.8906 3.99294 -0.306808 -3.71184 -1.40707 -5238 6 21.4819 20.9256 37.2108 -8.76322 20.972 13.918 -5239 4 22.36 21.3309 37.2026 5.25525 -6.97128 0.105034 -5240 4 21.5739 19.9858 37.0637 7.9716 -15.2147 -3.23728 -5241 6 18.467 41.0278 0.654954 -19.554 -29.5721 -12.8619 -5242 4 17.5024 41.1258 0.530294 8.77033 6.01734 2.0842 -5243 4 18.8042 41.8885 0.845086 4.40915 26.8371 2.49279 -5244 6 41.3548 41.7118 25.1844 12.9409 14.5374 -0.392323 -5245 4 40.9222 40.8883 25.4041 -6.90081 -12.2223 3.22908 -5246 4 41.5202 41.6634 24.2378 -1.56977 -0.361026 -1.444 -5247 6 27.6369 28.1312 3.93858 39.9773 31.9241 -60.8173 -5248 4 27.7577 28.1455 2.91253 -1.05119 3.80663 52.0412 -5249 4 26.945 27.5412 4.09124 -36.8498 -31.9254 8.70709 -5250 6 18.2839 10.5111 31.4966 0.533258 -0.0130678 0.979798 -5251 4 17.4029 10.1636 31.5665 -10.6602 -13.9647 -0.00296819 -5252 4 18.1106 11.4466 31.5267 10.9856 11.4938 1.12981 -5253 6 11.3036 37.9694 14.764 4.77413 -10.0896 11.5971 -5254 4 10.7874 37.239 14.4221 -9.53089 5.23111 -9.63971 -5255 4 11.7579 37.5414 15.5118 -2.30342 16.6377 -5.07599 -5256 6 0.816524 18.1414 27.5647 20.1272 -0.3628 -0.469578 -5257 4 0.17179 17.4415 27.469 -11.396 -5.37013 -1.78049 -5258 4 1.63281 17.6507 27.785 -7.45447 11.2502 -1.88757 -5259 6 36.8008 10.7378 20.295 8.4208 9.86458 8.47872 -5260 4 36.1948 10.0642 20.0001 -9.44027 -8.16387 -5.04241 -5261 4 36.5983 10.8279 21.2363 1.65531 0.40354 2.85938 -5262 6 47.4201 25.5213 8.04394 8.74054 5.57223 -13.14 -5263 4 47.3566 25.6372 7.0634 -2.71671 -4.96685 23.4826 -5264 4 46.5708 25.2582 8.40304 -6.39129 0.734124 -5.55138 -5265 6 13.9238 35.1275 16.0037 32.5083 18.1998 3.59786 -5266 4 13.2022 34.5755 16.1957 -32.489 -30.3694 18.6715 -5267 4 13.7597 35.4303 15.121 4.25156 9.41728 -20.5426 -5268 6 29.562 35.3734 16.1776 -35.0835 -2.07929 -8.00281 -5269 4 30.2224 34.9599 16.7245 13.9673 -5.91711 9.2078 -5270 4 28.7051 34.8863 16.2926 25.5199 12.926 -4.35301 -5271 6 29.4722 25.8866 32.4187 14.354 2.72026 -23.1845 -5272 4 28.9025 25.7608 33.1796 -14.4011 -9.23541 2.43376 -5273 4 29.1922 25.3818 31.6086 -3.9853 6.0929 23.1903 -5274 6 24.1343 2.13601 25.4438 45.8363 12.8335 -27.0328 -5275 4 24.6226 2.81425 24.8647 -23.4035 -21.9591 22.2831 -5276 4 24.7019 1.32842 25.3981 -18.0817 13.4017 1.18969 -5277 6 4.54354 34.4275 19.14 11.1292 -12.0398 21.377 -5278 4 4.4735 34.5954 18.1883 -15.738 1.03246 1.7136 -5279 4 3.71635 34.4131 19.6775 9.89222 2.06937 -18.6971 -5280 6 10.1248 17.2257 14.3121 -1.66581 -5.60367 -9.60454 -5281 4 10.2583 17.5937 15.1679 8.8306 2.43924 21.0325 -5282 4 9.4989 17.8227 13.9164 -6.75609 1.38519 -13.487 -5283 6 21.4392 41.7587 34.6855 22.2624 7.769 -11.2018 -5284 4 21.5032 41.1211 35.405 -13.4071 -7.19641 7.36579 -5285 4 20.544 -0.0182627 34.3462 -4.72666 -12.2957 11.4101 -5286 6 36.1543 24.108 12.5954 -4.82194 -9.49577 -8.67068 -5287 4 35.691 23.694 13.3698 5.25066 1.62288 -23.6525 -5288 4 35.776 23.8018 11.7194 2.97337 4.42231 26.8685 -5289 6 49.5838 18.601 19.9434 7.37368 0.836531 -4.03301 -5290 4 50.0063 19.3607 19.4891 -2.40205 -12.3461 5.19746 -5291 4 50.2865 17.9356 20.0577 -3.44895 8.52353 -2.14521 -5292 6 1.26001 7.05318 14.4907 38.3056 -26.8237 -27.7837 -5293 4 1.8201 6.82299 13.6677 -23.9217 11.4061 34.9177 -5294 4 1.48256 6.35829 15.148 -4.21477 12.5307 -9.57675 -5295 6 12.7431 22.7759 31.2417 -21.5742 -17.6245 -17.2109 -5296 4 12.7068 22.0167 30.6251 -0.189583 12.5272 11.0438 -5297 4 13.6543 23.0267 31.2833 20.8009 4.17698 1.04357 -5298 6 8.18693 18.6259 27.8062 12.2535 -2.56913 -7.18349 -5299 4 8.40416 17.6764 27.919 2.05523 15.8207 -2.89848 -5300 4 8.90605 19.0032 27.258 -7.77238 -10.2714 7.52916 -5301 6 52.132 28.0244 15.3085 -5.0475 -8.46487 8.97907 -5302 4 52.2845 27.4141 14.5747 1.7297 4.34316 -0.517396 -5303 4 52.1194 28.9169 14.9336 2.1814 -6.82244 -4.33507 -5304 6 52.6909 21.916 10.0977 -8.33066 3.09691 2.06611 -5305 4 53.4463 22.3007 10.5387 10.5159 5.84972 4.87058 -5306 4 52.7807 22.2562 9.19728 -3.40401 -0.944397 -1.81328 -5307 6 22.3502 5.78024 2.67711 -1.19821 4.70475 8.9403 -5308 4 22.3462 5.61537 3.63751 1.98719 -8.03511 -7.01348 -5309 4 22.5962 4.95479 2.25163 2.53332 -12.0932 -0.158426 -5310 6 15.4205 16.2192 21.8867 5.02822 24.0999 -40.4778 -5311 4 14.4784 16.2102 22.0595 -10.022 -3.20892 10.2198 -5312 4 15.4767 16.6809 20.9929 2.09736 -16.6333 30.6862 -5313 6 28.7089 41.2927 33.91 5.52796 3.54283 5.25404 -5314 4 28.727 40.4953 34.4564 -2.79359 -2.24742 -0.170863 -5315 4 27.7951 41.4466 33.6263 4.57527 -2.88437 3.84631 -5316 6 9.01739 31.2727 18.2059 -18.1749 -3.84142 11.7815 -5317 4 8.98151 32.2312 18.3694 0.025829 -3.44513 1.18933 -5318 4 8.52849 30.7949 18.9304 13.8496 11.5721 -17.6376 -5319 6 20.5529 20.3981 18.1799 -10.2473 -3.12886 -8.71499 -5320 4 21.0329 20.6151 18.9854 0.125323 4.65459 7.73128 -5321 4 19.8496 21.0773 18.075 13.4895 -10.4913 3.92819 -5322 6 53.9703 14.7072 37.8312 5.01214 -4.5628 8.74013 -5323 4 53.4666 15.4974 37.9319 -5.56379 24.6001 14.4542 -5324 4 53.6093 14.375 37.0321 1.20033 -18.5897 -21.23 -5325 6 28.9035 15.3885 18.8586 45.4636 -15.1916 -0.680493 -5326 4 29.8469 15.0873 18.5932 -41.6456 12.1347 6.71251 -5327 4 28.9115 15.3505 19.8299 -3.5302 1.25595 -2.12016 -5328 6 2.00256 25.8212 18.9096 3.72723 11.471 14.7099 -5329 4 2.26458 26.6216 18.4327 2.14682 1.88771 -0.892997 -5330 4 1.76414 25.179 18.2501 -5.23937 -11.562 -15.1322 -5331 6 53.2507 40.704 24.2965 8.91441 12.4597 1.37217 -5332 4 53.4683 39.7911 24.0958 -2.511 -10.6834 -0.444896 -5333 4 54.079 41.1598 24.0633 -8.96863 1.63956 3.52407 -5334 6 47.5231 32.0042 22.8531 -14.3462 4.46803 -6.08063 -5335 4 47.3408 32.7709 23.4273 6.00779 -4.56073 2.25025 -5336 4 48.2766 31.5253 23.2067 4.67997 4.39959 7.43042 -5337 6 24.6197 26.1463 33.0089 -12.4366 -5.18424 3.68853 -5338 4 24.4183 25.6868 33.835 -4.3875 -0.159577 -1.83724 -5339 4 25.4547 26.5812 33.1385 10.0429 5.3772 -3.83199 -5340 6 21.3442 17.0884 39.4824 -9.75867 4.42788 -12.86 -5341 4 22.0786 16.6105 39.8509 9.0034 -0.419098 8.66004 -5342 4 20.9617 17.649 40.1682 3.71874 -0.284678 5.70811 -5343 6 11.0324 40.4486 17.0358 15.7971 -30.8577 -26.0801 -5344 4 11.6842 41.1185 17.2103 4.65986 12.9737 2.4903 -5345 4 11.491 39.8695 16.3608 -26.1319 15.9634 25.4848 -5346 6 20.3416 21.2702 39.8615 -24.9835 10.9638 22.3655 -5347 4 20.689 20.9793 39.0389 13.9219 -9.37305 -28.7546 -5348 4 21.0638 21.2843 40.4958 4.25493 1.29328 -0.298347 -5349 6 2.11091 29.6941 22.5934 -5.9509 -23.8702 -11.6938 -5350 4 1.45034 28.9715 22.5035 1.67869 13.3355 3.97539 -5351 4 2.94117 29.2559 22.3631 0.0654014 9.01208 -1.60678 -5352 6 36.7558 30.2897 35.4506 24.3729 -18.3256 16.5828 -5353 4 36.1768 30.1398 36.2224 6.47664 5.98183 -7.75951 -5354 4 37.6324 29.8684 35.7011 -26.9845 14.5763 -5.36474 -5355 6 12.9471 4.31284 37.9204 -6.90268 -11.166 6.10722 -5356 4 12.3078 3.59731 38.1765 12.7034 25.1114 3.17689 -5357 4 12.7446 5.19856 38.3152 -2.40344 -19.0082 -2.01981 -5358 6 38.3332 5.26794 18.4655 -19.3496 19.9027 -29.1997 -5359 4 37.4721 5.17942 18.8804 2.72791 -1.29988 8.64573 -5360 4 39.0241 5.01488 19.0552 15.587 -10.1496 24.0772 -5361 6 10.4858 9.23289 21.7404 -25.2332 -4.10139 2.16313 -5362 4 10.1465 9.25623 22.657 12.6022 -3.18555 -3.91704 -5363 4 11.447 9.27854 21.7188 5.40032 0.87934 7.2107 -5364 6 0.505771 41.0407 17.3245 -0.427706 37.3637 0.906459 -5365 4 1.03474 40.3115 17.5973 10.8601 -24.0642 8.3812 -5366 4 1.07952 41.8285 17.484 -10.202 -14.0113 -5.73388 -5367 6 4.10283 5.07754 6.43738 -38.2782 -14.6693 -26.7901 -5368 4 4.80956 4.44559 6.48511 17.8781 -6.62955 4.00539 -5369 4 4.33824 5.81877 6.9517 16.1672 26.1823 21.8329 -5370 6 11.4353 25.4218 0.164599 -6.84764 4.42394 -1.26617 -5371 4 11.3082 26.3017 0.56247 4.23965 -3.25035 1.30302 -5372 4 12.32 25.1006 0.40702 -4.64442 7.63092 -0.276853 -5373 6 7.41885 21.5502 8.10769 10.495 -13.722 -26.2993 -5374 4 7.61759 21.2522 7.17802 -11.0567 9.56016 28.8323 -5375 4 8.26229 21.8826 8.44859 -7.90548 -1.09713 -4.6635 -5376 6 47.5869 16.3678 25.2584 -15.0789 15.5873 -32.807 -5377 4 46.6352 16.1327 25.0388 32.9447 8.00435 6.4503 -5378 4 47.9767 16.8704 24.4584 -11.2605 -20.3751 33.7323 -5379 6 30.9209 19.4939 39.8451 -11.8548 28.7526 -24.1689 -5380 4 31.8555 19.5183 40.0202 17.1254 -10.6903 10.4692 -5381 4 30.8076 20.3562 39.3598 -8.87252 -26.4956 11.5622 -5382 6 20.3775 24.0331 39.393 16.2123 32.2964 -6.62361 -5383 4 19.46 24.2872 39.3788 -17.3162 -0.971439 2.40317 -5384 4 20.4139 23.0995 39.5119 -7.32592 -29.4126 2.4841 -5385 6 45.906 21.2665 41.1719 -24.2736 -11.4825 -0.885762 -5386 4 46.5804 21.1569 41.8486 15.7955 10.6383 -1.5802 -5387 4 46.0859 21.9477 40.5132 15.7742 6.36757 6.57249 -5388 6 32.5682 28.1996 30.46 3.6658 -10.99 6.0107 -5389 4 32.938 27.299 30.6104 -6.7941 21.8776 -2.09353 -5390 4 33.2105 28.8285 30.8344 -2.85996 -8.65293 -4.24176 -5391 6 18.0144 1.30598 27.0418 -16.6632 -1.71712 -0.445992 -5392 4 17.1007 1.69106 27.0468 26.0213 -5.17059 4.63351 -5393 4 18.4653 1.60291 27.8546 -9.34219 2.14994 -8.02835 -5394 6 39.3706 24.9704 21.8707 -3.8719 -7.6304 -3.05608 -5395 4 39.4638 25.9303 22.0078 -2.06007 -5.24545 2.56571 -5396 4 38.5004 24.7369 22.2528 8.08795 9.92494 -4.1564 -5397 6 33.5838 21.3134 22.0984 8.18441 -4.13225 6.82001 -5398 4 32.7138 21.3502 21.682 2.4933 6.37883 -5.99313 -5399 4 34.1113 22.092 21.8324 -12.1677 -4.37971 -1.53996 -5400 6 40.113 14.9986 15.7558 -14.3933 -54.3129 -47.4443 -5401 4 39.335 14.6192 15.2293 31.4969 18.6384 20.9479 -5402 4 39.7901 15.7154 16.2477 -17.7573 36.9578 24.811 -5403 6 32.6916 17.9228 6.36161 -9.89813 9.73379 -21.0853 -5404 4 32.6423 17.3002 7.0662 1.70901 -17.6566 26.5232 -5405 4 32.2464 17.4542 5.63975 -0.790726 3.03073 -5.51736 -5406 6 50.4678 15.9334 31.144 -39.7004 -26.5385 31.9374 -5407 4 51.253 16.1743 30.7093 39.9028 11.8107 -24.2063 -5408 4 50.5343 14.9829 31.3801 -1.18751 16.0768 -7.78774 -5409 6 23.825 29.3336 31.6412 17.8706 -6.79638 -8.14744 -5410 4 23.7507 29.695 30.7549 -4.03414 2.57591 0.878238 -5411 4 24.7016 28.8907 31.6365 -14.4802 6.46497 6.02506 -5412 6 25.0497 41.6479 38.28 3.49637 2.98657 -6.73496 -5413 4 25.6848 41.2957 37.6072 -14.3525 10.6226 12.6055 -5414 4 24.5759 0.544247 37.957 10.7828 -14.7666 -1.7986 -5415 6 14.3338 25.4719 8.00129 -34.0608 -17.9542 9.33499 -5416 4 15.0375 25.807 7.49197 32.7442 17.1809 -19.3974 -5417 4 13.7504 25.049 7.33286 9.67269 6.09785 11.4563 -5418 6 17.2157 20.7463 5.33337 -33.6161 12.1619 46.6806 -5419 4 17.4746 20.2104 4.61987 19.6997 -12.8632 -39.6831 -5420 4 17.6039 21.6267 5.33982 9.69266 2.06371 -12.0346 -5421 6 18.8632 10.9532 23.7128 -6.45661 -28.7698 -18.1749 -5422 4 18.5024 10.4645 22.9505 4.54871 -4.25462 9.96764 -5423 4 18.7195 11.8343 23.4273 2.43458 32.1183 3.28403 -5424 6 7.79185 41.3929 11.0465 3.42517 6.73563 9.75028 -5425 4 8.03468 40.5075 11.3396 -5.29569 0.405018 -3.04036 -5426 4 8.54504 0.0288503 11.3371 -5.83581 0.184768 -2.76634 -5427 6 48.7029 23.1861 34.0656 -21.7207 -4.36764 -18.9996 -5428 4 48.0685 22.9631 33.3267 17.6914 7.49561 22.5851 -5429 4 49.5647 23.2306 33.645 9.38657 -0.0360042 -3.96825 -5430 6 53.7171 23.5593 15.3279 7.98903 18.1369 9.52531 -5431 4 53.9889 24.0987 14.5512 -16.5338 -16.4319 -0.0123194 -5432 4 53.1679 22.8017 15.1046 0.0193492 2.24596 -12.2178 -5433 6 22.2331 5.62812 9.84443 -1.57081 2.06392 2.32933 -5434 4 21.8309 4.81719 9.48029 9.17546 11.008 0.0652314 -5435 4 22.6135 6.1669 9.11622 -10.9942 -17.7486 8.8339 -5436 6 33.6597 8.39756 9.07438 12.888 -3.30103 7.28088 -5437 4 32.9598 8.97334 9.38893 -12.3292 7.33717 0.65351 -5438 4 33.4682 8.16911 8.16186 -5.09418 6.09353 -6.44604 -5439 6 47.3119 37.7194 20.3363 21.5156 22.744 3.03657 -5440 4 47.6473 37.5407 19.4464 -9.46862 -8.33692 4.35957 -5441 4 46.6883 37.0359 20.5464 -12.6113 -19.4741 -3.99141 -5442 6 30.8566 16.7294 10.6197 -45.1927 -36.7422 15.3603 -5443 4 30.4293 17.2093 11.3782 10.0419 -7.15869 -15.9692 -5444 4 30.3248 15.8445 10.5087 28.8517 44.18 3.4025 -5445 6 48.1145 27.7388 10.1259 3.61398 12.7601 13.975 -5446 4 49.0121 27.5791 10.4269 8.16567 7.74751 7.8449 -5447 4 47.9875 27.049 9.49259 -14.0608 -13.1923 -17.2023 -5448 6 27.3333 38.6223 25.6028 2.23096 -19.4823 3.9502 -5449 4 28.2552 38.3493 25.5855 1.31221 -11.4567 4.08925 -5450 4 27.4115 39.4856 25.2253 -6.51803 21.9055 -3.11379 -5451 6 33.3641 5.73966 21.4502 -17.8674 16.1521 -18.7045 -5452 4 32.7333 6.1391 20.8022 11.3762 -13.0233 18.1576 -5453 4 34.2053 6.04196 21.1266 17.0109 2.35293 -3.511 -5454 6 25.3113 5.14231 4.52483 0.627568 -0.448638 -4.7772 -5455 4 25.9311 5.01166 5.26368 -5.83567 -1.85096 0.781095 -5456 4 24.4169 4.85751 4.79359 12.9854 0.158453 3.02285 -5457 6 40.4761 35.641 19.148 -1.79116 -1.08437 4.96155 -5458 4 40.617 35.2798 20.0294 1.97887 -12.6912 2.42284 -5459 4 40.4316 36.5735 19.3404 -1.08207 12.5153 -8.94186 -5460 6 49.6577 30.6259 19.0198 10.1565 -2.14928 -32.2041 -5461 4 49.9169 29.8714 18.4657 1.24638 0.0316256 -4.24874 -5462 4 49.4705 30.2089 19.8368 -7.31172 -12.6811 36.7039 -5463 6 42.1447 28.3235 17.0346 32.2065 -21.7575 -5.76428 -5464 4 41.8825 28.1658 16.1189 -9.06503 7.62036 -2.3435 -5465 4 42.9622 27.7534 17.0825 -24.1402 18.2728 2.552 -5466 6 47.7039 24.5139 36.3396 16.4403 6.39896 -6.79461 -5467 4 46.9537 23.9582 36.5487 -4.01092 -10.0931 -4.11437 -5468 4 48.0889 24.2445 35.4833 -10.0455 -7.86437 4.89019 -5469 6 19.3463 26.9837 19.8062 -14.9609 -0.640093 12.1457 -5470 4 19.5138 26.0435 19.7544 7.81166 -12.6546 -12.1749 -5471 4 18.7209 27.0489 20.5386 2.91516 7.38851 -4.99075 -5472 6 47.0534 26.8134 37.524 14.5946 -27.4581 20.3182 -5473 4 46.5999 27.4025 36.9765 -27.9132 42.868 -22.1392 -5474 4 47.3287 26.1433 36.896 5.92816 -9.16339 3.59921 -5475 6 9.30604 24.6864 40.2824 32.5721 -4.72803 4.84631 -5476 4 9.7425 23.8424 39.9878 -14.1318 19.2209 8.44319 -5477 4 10.0514 25.1942 40.7028 -19.8613 -12.5192 -10.8686 -5478 6 14.4861 17.9115 14.2864 12.9549 -2.10551 -8.28408 -5479 4 13.7677 18.2592 13.7435 1.92348 1.2648 2.86628 -5480 4 15.2633 17.8567 13.6783 -18.4643 2.67645 15.1406 -5481 6 37.1346 38.6824 18.7128 7.24689 -5.58535 -9.53541 -5482 4 36.7159 39.5508 18.578 6.84706 -0.690413 -9.37485 -5483 4 37.7177 38.457 17.9456 -10.6272 10.0511 7.65618 -5484 6 11.4119 5.91281 21.4549 8.51563 -6.63227 17.2429 -5485 4 12.0074 5.45436 22.0841 -12.0343 5.82261 -11.8758 -5486 4 10.9825 5.24051 20.9122 -1.087 -4.70833 -2.40093 -5487 6 4.25375 30.708 16.2346 29.3973 -34.9884 0.269827 -5488 4 4.09384 31.4404 15.6668 -11.3131 25.7038 -10.6546 -5489 4 3.7498 30.7826 17.0293 -13.4231 7.50595 13.7704 -5490 6 17.6719 16.0027 27.067 -23.8279 -26.0778 -36.6424 -5491 4 17.4271 15.046 26.968 10.0078 22.1048 9.82572 -5492 4 17.2008 16.3672 26.2667 15.5193 1.39518 21.9495 -5493 6 36.5109 8.65039 40.4308 12.8187 7.82554 4.51092 -5494 4 36.6212 9.57953 40.6523 1.70353 1.63484 0.0365135 -5495 4 35.6422 8.38915 40.7323 -7.59123 -4.26386 -1.28756 -5496 6 13.6114 12.9582 3.02589 -9.62347 -2.84414 10.0553 -5497 4 13.2363 12.4097 3.76862 19.3807 16.1747 -17.4749 -5498 4 14.4444 13.4268 3.2396 -7.87441 -9.64772 8.81761 -5499 6 38.5595 20.1494 21.6232 12.4359 -2.6335 16.4863 -5500 4 39.2259 20.3435 20.9591 -1.48691 0.443177 -6.45697 -5501 4 37.7118 20.0829 21.2013 -17.1516 -4.14152 -12.2545 -5502 6 50.9933 10.2578 30.842 -13.0607 -20.693 1.71035 -5503 4 51.4592 11.0512 30.6346 13.219 20.5706 -0.472754 -5504 4 50.4501 10.1493 30.0523 -4.00654 -4.85851 -2.78428 -5505 6 16.2749 2.41767 41.3132 30.43 46.2693 -10.4997 -5506 4 15.891 1.63581 41.6436 -18.412 -43.9133 0.0464609 -5507 4 16.2795 2.47169 40.3396 -9.09423 -14.5759 6.47164 -5508 6 16.5834 4.98938 41.8776 -7.21709 18.0228 -35.1788 -5509 4 16.7462 5.00964 0.881122 10.2158 10.5242 44.5139 -5510 4 16.3516 4.0781 41.7536 -3.71457 -12.9135 -9.58407 -5511 6 38.2173 37.6461 20.9885 34.7311 9.53448 3.02785 -5512 4 38.1039 38.1836 20.1861 -3.89758 -6.06348 6.62032 -5513 4 39.1638 37.7895 21.271 -30.6928 -4.57838 -6.40603 -5514 6 27.3006 1.89931 15.7822 -29.9599 0.296682 7.03709 -5515 4 27.5073 1.31215 15.0574 1.93116 -3.76907 -9.96281 -5516 4 26.3073 1.90747 15.8082 23.9237 -0.0762349 1.33551 -5517 6 29.0265 12.4386 37.8107 0.525722 -10.271 3.33822 -5518 4 29.5022 13.2884 37.7591 0.646351 -6.15481 8.15455 -5519 4 29.2991 11.9227 38.6151 -0.523918 21.8031 -11.8471 -5520 6 46.0742 20.1649 18.9021 10.3528 7.89056 -10.7305 -5521 4 45.1842 20.5502 18.8696 3.90233 0.901411 -3.14496 -5522 4 46.6469 20.7119 18.3183 -8.66547 -7.99067 8.59505 -5523 6 2.04022 38.6829 18.5084 -2.98341 9.82285 -40.3455 -5524 4 2.90324 38.7749 18.9245 -0.612017 -3.29975 20.9344 -5525 4 1.3228 38.3823 19.0758 6.43327 -3.78011 20.6074 -5526 6 44.0503 24.9822 25.9794 4.67294 -4.59524 3.88497 -5527 4 44.3373 24.0607 26.0767 4.76241 4.2408 6.41339 -5528 4 43.5759 24.9717 25.1449 -4.92835 3.44315 -2.97359 -5529 6 5.98031 26.6293 4.53551 9.30387 5.64625 14.1271 -5530 4 6.57491 27.1353 5.14729 -11.3776 -17.0368 -12.135 -5531 4 6.21313 25.677 4.5841 -4.82905 19.4284 -2.02229 -5532 6 0.0924267 23.2133 10.9333 1.42961 0.53672 3.80218 -5533 4 0.717354 23.7388 10.4004 2.9288 -9.65077 10.1872 -5534 4 0.580921 22.6863 11.5989 -3.01683 9.30052 -9.37626 -5535 6 39.1222 20.6154 12.8741 28.3348 2.95161 0.461931 -5536 4 40.0468 20.8249 13.1753 -23.4009 -9.33487 -2.82098 -5537 4 38.9932 21.1408 12.0685 -0.0080483 -0.226832 2.68059 -5538 6 39.959 39.9495 18.871 8.01281 1.93571 -21.8826 -5539 4 39.6441 40.4313 18.0693 6.09748 -11.7745 18.4856 -5540 4 39.3412 40.1359 19.5607 -16.2687 5.42221 11.8382 -5541 6 49.288 23.0046 30.5128 21.2206 -9.75551 18.5897 -5542 4 49.5389 23.7528 30.0013 -1.98497 24.1116 -29.9204 -5543 4 49.9896 23.0569 31.1809 -5.40626 -11.587 6.30696 -5544 6 10.3545 2.34292 9.14765 -20.562 40.259 12.8074 -5545 4 10.1012 1.5797 8.68555 -3.02669 -36.876 -18.9145 -5546 4 9.58966 2.94108 8.9894 20.4134 -0.423974 9.05106 -5547 6 9.6115 40.9317 19.7379 12.0905 -27.6191 -4.08509 -5548 4 9.69139 40.7751 18.7589 3.32448 -0.840478 24.839 -5549 4 9.96472 40.0953 20.2033 -15.7711 32.9781 -27.126 -5550 6 29.2535 5.10379 17.4957 6.62295 15.7752 6.05206 -5551 4 28.9547 4.7998 16.6324 -1.76299 0.290572 -5.22762 -5552 4 29.5626 6.02275 17.3534 -3.29284 -14.1281 1.20249 -5553 6 27.0956 15.411 3.22262 8.43004 -47.4217 3.28637 -5554 4 27.2677 16.3043 3.38591 1.16524 52.1129 6.18754 -5555 4 27.741 14.9724 3.82188 -13.792 3.46242 -10.72 -5556 6 32.8341 39.3821 25.1177 -1.66938 -44.1854 21.376 -5557 4 32.6253 40.2767 24.9331 -7.27917 31.8978 1.68524 -5558 4 32.4689 39.1753 26.0219 6.68592 11.3878 -26.9617 -5559 6 34.9613 7.8883 31.2358 4.6626 36.0744 6.61898 -5560 4 34.1778 8.39814 31.5057 7.62156 3.23778 -2.6687 -5561 4 34.6431 7.01199 31.2355 -6.57887 -35.8668 -2.78431 -5562 6 6.13276 36.7597 26.1434 10.8988 16.6869 20.3463 -5563 4 6.63888 37.4372 26.6797 -12.2659 -21.448 -21.9021 -5564 4 6.61066 36.5785 25.3331 5.0666 0.722926 -2.43587 -5565 6 6.00975 25.8323 24.1014 -4.47961 0.932019 -2.36624 -5566 4 6.35352 25.3647 24.9068 -18.3984 14.8695 -13.0656 -5567 4 5.16189 26.3111 24.2876 18.65 -15.8322 7.58859 -5568 6 45.6302 24.3945 2.56021 19.8484 -5.54431 -0.0961329 -5569 4 46.4674 24.0527 2.19931 -2.34639 0.0383291 -2.49188 -5570 4 45.6784 24.1611 3.48508 -4.52597 -1.56916 11.2469 -5571 6 15.5147 11.7041 32.683 14.9804 20.126 19.7749 -5572 4 15.7333 12.537 33.1619 -4.31998 -20.325 -9.45866 -5573 4 14.9494 12.0119 31.9786 -9.0483 1.88099 -11.1618 -5574 6 46.4109 17.7015 37.4781 -27.0258 -32.7931 -28.9932 -5575 4 46.5427 17.8951 38.3867 3.19976 6.65122 29.0636 -5576 4 45.8763 16.8534 37.4192 15.4316 28.8096 -0.764517 -5577 6 39.7197 20.9143 18.534 -24.0731 20.2285 32.8184 -5578 4 40.3775 20.5463 17.9571 20.7324 -0.0260386 -6.5243 -5579 4 40.0771 21.5962 19.1648 -0.0511872 -19.8333 -22.8182 -5580 6 23.8035 28.041 36.6748 9.0016 14.1447 -6.24075 -5581 4 23.3139 27.2938 37.064 2.44252 16.2828 7.25552 -5582 4 23.789 28.845 37.2599 -7.88527 -27.7019 -2.97202 -5583 6 23.2344 0.634844 30.8976 -0.384503 -14.0448 -5.97485 -5584 4 23.3889 41.8653 31.5825 6.30765 2.44689 -9.38002 -5585 4 23.8441 0.49945 30.133 -8.72578 -2.57312 14.648 -5586 6 37.1436 6.89172 28.2858 -3.37167 6.44507 30.6351 -5587 4 36.8056 6.23733 28.9583 11.2574 17.9183 -21.3683 -5588 4 37.4325 7.68669 28.8192 -8.94015 -21.4647 -17.7418 -5589 6 3.23535 6.60909 12.3935 -1.87368 1.73448 8.36027 -5590 4 3.03832 6.9284 11.4867 8.20532 -9.84476 7.71099 -5591 4 3.52123 5.67427 12.3822 -6.77188 11.8795 -6.70084 -5592 6 12.6173 19.1518 31.1213 -5.69854 -18.2223 8.29425 -5593 4 12.5903 18.2248 31.5183 -0.203161 27.8336 -18.7857 -5594 4 12.2771 19.1425 30.2049 2.23067 -5.60852 14.6148 -5595 6 15.1884 38.3149 41.5578 -3.57026 -0.303434 0.776802 -5596 4 15.4085 38.7623 40.7331 -1.55695 3.41656 0.7558 -5597 4 16.0064 37.8692 41.7958 4.70682 -3.66196 2.37744 -5598 6 49.6308 33.3399 19.6427 -23.754 -26.2674 -4.71234 -5599 4 48.6425 33.4171 19.8493 35.7001 -9.4047 -10.4581 -5600 4 49.8006 32.395 19.3286 -9.63678 35.3831 11.1391 -5601 6 6.36026 2.78098 29.8944 3.74937 13.951 -9.77631 -5602 4 6.39713 3.75696 29.8119 -0.635871 -14.0149 2.80012 -5603 4 6.09114 2.63212 30.8044 -1.55083 -4.44243 9.60337 -5604 6 13.1715 31.7798 30.2783 -11.6407 3.9064 -21.9894 -5605 4 12.793 31.9725 29.3819 8.72012 -0.590438 18.6573 -5606 4 12.9685 30.8401 30.4245 2.82441 5.28785 4.26217 -5607 6 32.3245 32.246 24.8932 -0.334642 -17.4514 3.51608 -5608 4 32.5833 31.3985 24.4266 1.55373 29.7789 3.70352 -5609 4 32.7413 33.0821 24.5914 4.2936 -14.9539 -9.40787 -5610 6 41.9919 14.5701 37.4124 -31.8928 -38.2057 -11.1184 -5611 4 41.1925 13.9916 37.278 11.7187 28.3557 2.93562 -5612 4 42.6351 13.8531 37.4242 20.2579 6.94588 1.70752 -5613 6 11.8923 7.24234 27.6655 -13.1666 -25.4093 6.94854 -5614 4 11.7936 6.42612 28.2118 8.91213 18.8361 -2.40188 -5615 4 11.255 7.06027 26.9538 4.64331 9.73453 -0.841263 -5616 6 14.1973 37.538 6.88791 4.07782 -38.2298 -28.3639 -5617 4 14.4575 38.4426 6.80778 6.05638 30.4198 1.96843 -5618 4 14.5936 37.1092 6.07523 -12.6749 10.0326 27.426 -5619 6 14.2479 30.6948 36.0545 7.37408 36.4971 9.0133 -5620 4 14.3981 30.7629 35.1101 2.39159 -10.6067 -11.9788 -5621 4 14.1779 29.7876 36.2972 -1.09854 -35.7585 -0.14866 -5622 6 16.4334 33.6494 5.49228 -9.96541 -28.1856 -5.39099 -5623 4 16.7983 34.5397 5.45321 9.37649 -3.55324 -12.1003 -5624 4 16.7788 32.9912 4.81355 -0.655183 31.9156 12.6517 -5625 6 23.0317 17.1547 7.8473 13.6053 -0.132883 9.10362 -5626 4 22.1841 17.362 7.40272 9.91908 10.567 10.3381 -5627 4 23.4804 17.9296 8.30446 -24.7767 -19.3244 -18.4116 -5628 6 51.7425 20.8913 27.7088 32.6403 -5.30395 6.54704 -5629 4 51.4526 20.615 28.6066 9.31531 5.01366 -13.1678 -5630 4 52.7523 20.9899 27.7096 -40.0215 -4.95426 2.55021 -5631 6 2.19474 27.6072 28.8013 -23.9703 3.8216 12.4498 -5632 4 2.89306 28.2617 29.0045 8.22653 -14.998 -10.5048 -5633 4 2.42593 26.8662 28.2089 10.4722 10.3682 5.46115 -5634 6 17.2069 14.3387 7.70681 0.210359 -30.5014 22.2216 -5635 4 16.8342 14.1932 8.62484 13.2745 1.87397 -27.442 -5636 4 17.791 13.5503 7.49447 -17.8498 26.4292 5.4189 -5637 6 12.462 8.93964 14.7065 0.798528 8.71873 -6.67623 -5638 4 12.2438 7.98523 14.5568 11.6803 11.8078 17.0064 -5639 4 13.0577 9.12873 15.4809 -12.5262 -17.6243 -12.8578 -5640 6 42.4139 38.0579 9.76413 -20.5008 17.2265 16.0611 -5641 4 43.2035 37.8944 10.2554 20.3834 -6.45835 6.72371 -5642 4 41.8905 38.6035 10.3913 3.31942 -7.4886 -15.3201 -5643 6 51.8227 30.3513 28.272 -27.6927 -20.9124 31.2363 -5644 4 51.4089 31.1514 27.9711 0.163888 16.7369 -10.597 -5645 4 52.6546 30.2313 27.8441 24.1641 3.9866 -16.3823 -5646 6 0.181148 18.531 4.58976 -5.95747 22.8787 14.3331 -5647 4 0.30783 18.164 3.72574 1.94264 -10.8238 -19.8991 -5648 4 0.385506 17.861 5.23812 2.38695 -15.8688 4.81738 -5649 6 34.1492 0.61754 2.99129 -49.6439 4.42439 -16.0687 -5650 4 33.2398 0.938351 2.63038 43.5613 -10.8791 15.5023 -5651 4 34.8325 1.13587 2.566 3.67212 10.3309 -6.27046 -5652 6 49.171 17.2374 23.1529 12.6877 -22.0026 -17.2704 -5653 4 50.1002 17.5391 23.0823 -12.4494 -3.65532 2.68691 -5654 4 49.1558 16.3609 22.6932 2.16788 22.8154 9.36775 -5655 6 23.1488 6.5083 23.6124 -20.5997 37.6057 -45.0229 -5656 4 23.0491 7.12001 22.8007 18.1878 -21.95 27.0503 -5657 4 22.2316 6.45775 23.8939 -1.28085 -6.53623 13.7239 -5658 6 11.0806 24.0842 29.2705 -8.73998 -10.3514 -18.9502 -5659 4 11.2441 23.4599 28.5168 0.0150655 10.4905 16.9308 -5660 4 11.7296 23.9083 29.9561 7.87164 -2.5542 2.12029 -5661 6 36.5429 4.08242 21.672 0.786556 -8.94696 -15.3954 -5662 4 36.4501 4.49554 22.5359 -3.35109 8.47972 1.84417 -5663 4 36.356 4.76727 20.9996 1.47044 -5.20042 11.1851 -5664 6 31.3053 25.6355 24.591 -3.66138 3.71718 3.54675 -5665 4 31.1335 26.2845 25.3159 5.93159 -20.4343 -13.8963 -5666 4 32.0778 25.0682 24.8002 -7.66178 11.3294 7.22687 -5667 6 42.6065 23.0403 14.7613 -16.8309 4.03618 -45.3098 -5668 4 42.9655 23.4598 13.9577 -8.276 -4.36486 -1.00498 -5669 4 43.204 23.3098 15.4118 29.6291 10.3091 46.448 -5670 6 14.3159 11.6727 8.8813 -14.5655 -17.9373 -12.2817 -5671 4 13.3434 11.4421 8.85146 29.9821 6.96631 -2.22077 -5672 4 14.7728 10.9717 8.34565 -11.3371 15.3318 14.175 -5673 6 21.498 2.14139 3.39648 14.7702 -17.8734 -6.06988 -5674 4 22.405 2.21099 3.73647 -11.0312 3.8274 -0.37696 -5675 4 21.4855 1.24815 2.9799 -4.51333 14.3419 9.54204 -5676 6 22.4606 27.6741 39.0725 -9.38699 -8.57051 -12.0691 -5677 4 22.9487 28.2157 39.6788 9.87489 12.9386 7.45564 -5678 4 22.251 26.9021 39.5804 -3.7481 -10.0177 3.53978 -5679 6 37.2705 33.4961 30.0614 -4.9469 -17.1986 11.1636 -5680 4 36.5019 32.9393 30.3108 14.0133 8.69925 -1.52787 -5681 4 38.0636 33.0902 30.4641 -13.5236 2.40347 -6.71067 -5682 6 41.8394 20.8621 40.0097 -20.8091 -17.9415 -11.9484 -5683 4 40.8821 20.7467 40.2088 17.4772 5.45688 -4.89215 -5684 4 42.2425 21.2111 40.795 8.11745 4.61319 15.3924 -5685 6 10.0509 31.1054 22.2556 20.3961 -18.8014 17.2446 -5686 4 9.98499 30.8639 23.2007 -4.95143 3.66172 -13.3958 -5687 4 9.23459 31.4918 21.9926 -24.2979 8.76968 -3.95477 -5688 6 24.2243 35.3747 6.62617 -9.42531 -3.96828 -6.7527 -5689 4 23.2865 35.2144 6.56466 -9.91939 -6.68958 -24.4488 -5690 4 24.2401 35.6133 7.54088 22.4532 10.3619 17.5563 -5691 6 54.2249 13.3694 18.759 -24.737 -0.349871 -1.41807 -5692 4 53.5933 13.3703 18.006 15.3609 1.78219 9.05355 -5693 4 53.6566 13.499 19.5435 10.7967 -0.400371 -8.89572 -5694 6 12.4855 25.1013 17.4456 -6.57337 13.5018 5.68311 -5695 4 11.9686 25.7405 17.9864 9.67417 -13.0798 -6.23069 -5696 4 12.9177 24.4729 18.0482 -8.67745 6.31928 -4.55572 -5697 6 22.3956 33.969 18.8874 -5.8063 -1.6479 -7.81353 -5698 4 22.8035 34.4497 18.1359 -8.0332 -6.19684 5.18696 -5699 4 21.6693 33.408 18.5182 22.6878 13.045 2.20471 -5700 6 24.4435 12.9292 5.84415 8.74588 -19.8564 16.0901 -5701 4 24.6262 13.8512 5.99703 -0.326218 20.1414 -4.57271 -5702 4 23.8078 12.8376 5.13214 -2.90401 5.95194 -4.82348 -5703 6 13.3959 11.2335 28.6038 -6.74888 -5.61354 -5.54718 -5704 4 13.7674 10.4842 28.0847 -9.93712 8.82772 12.9583 -5705 4 12.6218 10.8864 29.0903 8.08376 -4.51111 -11.0518 -5706 6 20.9645 34.7015 21.139 -6.51648 1.45471 -0.425004 -5707 4 21.4543 35.0255 21.9119 2.52902 -3.67403 -7.94594 -5708 4 21.5071 34.7067 20.3201 -1.1119 -0.149268 16.7291 -5709 6 37.136 34.5081 26.161 6.62209 -8.97684 -22.2932 -5710 4 37.2438 34.333 25.2112 -5.73965 -6.14541 10.65 -5711 4 37.5173 35.375 26.2088 1.33918 12.2816 12.8311 -5712 6 49.3593 27.1123 23.4681 27.9614 -13.0657 2.71617 -5713 4 48.46 27.3383 23.3348 -38.0547 10.3981 -3.53627 -5714 4 49.5827 26.632 22.6632 1.14175 -6.15755 -6.01297 -5715 6 2.6463 41.7198 27.6524 7.3894 17.9878 -25.5957 -5716 4 2.49639 41.7504 26.6775 -8.79282 -10.4379 14.5056 -5717 4 3.38399 0.440368 27.7439 -10.0848 -7.80081 10.7778 -5718 6 28.2486 5.66281 0.851705 -28.2484 -11.3463 5.20358 -5719 4 29.1342 5.88017 0.643235 30.8656 11.4658 -5.99415 -5720 4 28.269 4.69693 0.891643 -4.88577 1.64465 1.4719 -5721 6 46.3319 19.9354 30.6504 10.2867 19.401 8.99033 -5722 4 46.9123 19.9353 29.8821 -3.84989 -4.07474 -6.11394 -5723 4 46.5975 20.7732 31.0971 -12.3274 -18.5124 -2.17733 -5724 6 3.63748 25.7835 21.5531 -13.3498 -8.40935 -29.3244 -5725 4 3.82697 24.8656 21.7578 10.5845 0.467441 11.0774 -5726 4 3.24958 25.6945 20.6565 5.98204 10.7305 11.6574 -5727 6 2.75525 19.0991 29.6309 -15.3907 3.66354 13.2976 -5728 4 3.52302 18.6052 29.9384 7.69741 -2.11378 -3.28897 -5729 4 2.98375 19.5594 28.8227 11.6258 3.58084 -5.99316 -5730 6 11.8998 35.7779 24.2574 -1.81403 7.91701 -5.71356 -5731 4 12.4147 34.9912 24.3376 10.7342 -20.9531 7.85436 -5732 4 12.5443 36.3811 23.8879 2.19538 16 -3.69366 -5733 6 52.3427 30.4062 14.294 22.5839 4.39347 1.37497 -5734 4 52.8745 31.0934 14.7488 -8.66891 -1.23278 -4.46489 -5735 4 51.4935 30.7804 14.0876 -13.5204 11.8147 1.32314 -5736 6 0.0822874 24.3672 32.1291 -8.34182 -9.5272 -6.40877 -5737 4 0.828194 24.8082 31.7001 -5.59692 5.0286 6.41936 -5738 4 -0.0482457 24.7479 33.0025 4.35174 8.79498 5.58774 -5739 6 31.4966 23.7292 38.8152 19.1094 38.0757 -4.99319 -5740 4 31.5999 23.5133 39.7508 -8.21927 -12.2318 -1.63758 -5741 4 30.9751 23.0699 38.3783 -13.0662 -23.7861 4.62116 -5742 6 52.1169 21.6052 3.50792 14.3711 -14.904 -13.5765 -5743 4 52.8807 21.6364 2.89306 -16.3122 -4.91238 6.22228 -5744 4 52.1257 22.4771 3.8768 -2.65107 18.1744 9.91254 -5745 6 31.7478 33.9414 11.5999 6.40399 -14.705 -7.35618 -5746 4 31.326 34.316 12.3745 -3.98661 3.76902 9.36008 -5747 4 32.1024 33.0666 11.8569 -5.74966 15.1553 -0.43871 -5748 6 7.04869 17.6722 16.6738 15.5169 9.78585 -46.6303 -5749 4 6.86408 17.1452 17.4554 -1.12856 -17.4359 1.80272 -5750 4 7.18951 17.0724 15.8577 -9.09698 16.5018 49.1326 -5751 6 51.856 41.8666 22.1892 3.84753 25.5265 -21.3427 -5752 4 52.3772 41.4924 22.8897 9.65371 -13.9556 16.5062 -5753 4 51.0512 41.3628 22.1522 -12.8828 -14.9996 6.2925 -5754 6 50.8708 9.92691 25.9357 -19.3562 -16.2947 3.52683 -5755 4 50.5833 10.1225 25.0455 -2.85771 2.39787 -5.58996 -5756 4 51.6551 10.4289 26.0882 17.2727 16.0662 4.10656 -5757 6 8.99927 39.8664 13.8488 -8.14038 -13.6283 -23.156 -5758 4 9.59929 39.3497 14.3885 6.06913 -3.61279 3.55219 -5759 4 8.79522 39.3067 13.0547 7.60199 16.2117 22.1745 -5760 6 40.7023 25.5302 0.148896 6.79038 -13.4508 8.01702 -5761 4 40.3789 25.4701 1.07476 14.4856 1.96217 -11.1718 -5762 4 41.6802 25.6099 0.149801 -17.1473 -2.90233 2.89792 -5763 6 46.6909 7.84537 22.8702 9.17253 9.27189 2.7581 -5764 4 46.223 7.4121 23.6122 6.69651 11.5962 -1.82232 -5765 4 47.0858 8.70418 23.1544 -10.5797 -14.2101 5.83025 -5766 6 21.013 12.9106 9.96683 -11.4772 33.9385 12.3935 -5767 4 21.4714 12.292 10.5062 17.1864 -22.5118 18.142 -5768 4 21.2487 12.7153 9.07972 8.38308 -10.8862 -30.7653 -5769 6 24.8549 0.515446 28.6008 5.68052 19.4063 -7.13145 -5770 4 24.6132 0.0822417 27.7678 -2.25298 -0.561161 -0.933523 -5771 4 24.9931 1.46483 28.3802 -3.69568 -16.6941 4.65055 -5772 6 9.93738 22.6806 8.27387 -17.0851 30.8612 6.83622 -5773 4 10.4469 21.9921 7.84938 5.97494 0.327216 -18.4105 -5774 4 9.65147 23.3826 7.61609 12.4321 -25.0338 8.46255 -5775 6 33.2759 9.25001 23.8237 4.47891 -44.2955 15.8461 -5776 4 33.2652 10.105 23.448 0.909732 36.8069 -18.0196 -5777 4 34.1325 8.84557 23.5962 -5.93924 6.51534 1.57833 -5778 6 47.795 20.3665 34.2866 5.36639 25.6433 -13.2606 -5779 4 47.2589 21.0165 33.753 7.81309 -27.8153 16.882 -5780 4 47.2984 19.5618 34.502 -10.2742 8.68957 -7.27829 -5781 6 7.49437 13.498 41.0843 -1.51987 -1.91843 -16.5508 -5782 4 7.4491 13.1887 40.147 4.71488 4.53153 18.247 -5783 4 8.31974 13.1617 41.4819 -4.68073 -1.19795 -7.02436 -5784 6 9.95832 23.5973 1.60681 5.21402 2.49741 5.68021 -5785 4 10.4402 24.1882 0.998507 -5.12041 -6.82862 1.89989 -5786 4 9.65493 22.8254 1.1174 1.14228 -2.219 -8.51506 -5787 6 27.3184 14.1623 11.3341 -13.0256 18.3326 19.191 -5788 4 27.0532 14.8043 10.6617 -0.288735 -3.87647 -1.15481 -5789 4 27.1082 14.6278 12.1878 10.7132 -11.7932 -20.1286 -5790 6 25.8363 31.783 17.8928 12.257 -31.4953 -8.75538 -5791 4 26.5912 31.2312 17.6268 -16.3657 -3.28218 2.7807 -5792 4 26.257 32.5845 18.0942 8.13437 40.9862 10.9181 -5793 6 28.5106 34.3419 0.227626 33.3873 17.7784 12.057 -5794 4 28.9852 33.8482 0.904042 3.3493 0.859906 2.37016 -5795 4 27.7339 33.8559 0.0766936 -35.6263 -19.3635 -8.63216 -5796 6 39.4752 27.6784 22.7097 42.3367 15.2059 -23.9811 -5797 4 38.5679 27.9307 22.8105 -22.3645 11.7157 0.32019 -5798 4 39.9498 28.4084 22.1978 -16.9125 -22.6846 16.1018 -5799 6 19.4034 35.5119 37.6428 33.5095 -11.1022 16.798 -5800 4 18.7953 34.9333 37.2031 -16.031 -7.23993 -11.3762 -5801 4 20.0399 34.8524 38.0282 -15.2165 20.9239 -9.15559 -5802 6 40.2577 30.223 10.7322 40.2352 -13.6393 -47.8395 -5803 4 40.0003 30.153 11.624 -20.3139 3.96126 40.955 -5804 4 39.7054 30.7997 10.2038 -14.6911 14.5022 3.62333 -5805 6 44.8252 28.467 36.0943 -27.9317 -39.6182 20.2271 -5806 4 44.1 27.9067 36.617 42.0807 42.9759 -26.5645 -5807 4 44.8315 29.4044 36.3472 -5.71594 -8.07431 0.279077 -5808 6 17.9328 13.9421 34.2756 -23.0398 37.6904 -16.8553 -5809 4 17.2847 14.658 34.0723 21.6532 -14.16 -3.36915 -5810 4 17.4769 13.4978 34.9742 -2.33669 -21.4636 20.9706 -5811 6 22.7722 11.8049 25.9053 18.1639 13.4769 -8.32772 -5812 4 22.5143 10.954 26.1764 -32.0329 -27.8082 11.3637 -5813 4 23.7113 11.6387 25.939 19.9678 17.8754 -6.33473 -5814 6 27.9844 31.9785 40.3628 4.4159 -7.73511 16.6787 -5815 4 28.3104 32.752 39.9101 2.36742 5.81951 -9.83175 -5816 4 27.6866 31.3262 39.7216 -3.89657 2.92736 -3.90823 -5817 6 29.7056 5.13899 29.6966 36.1554 -28.1732 -9.81385 -5818 4 29.3242 5.52633 30.4675 -11.5775 13.5815 21.5043 -5819 4 30.5867 4.74321 29.9895 -34.1051 15.4003 -14.984 -5820 6 3.10893 21.4798 2.76501 -7.99866 -19.5262 -7.43282 -5821 4 2.82658 22.3873 2.73831 -4.86294 14.1814 1.21532 -5822 4 2.47005 21.0041 2.20282 6.80672 4.92349 5.4824 -5823 6 13.6497 30.6638 39.7451 -45.1888 -1.5 -27.4221 -5824 4 14.5316 30.8766 39.996 26.4643 7.88404 -4.33129 -5825 4 13.4124 30.9677 38.8135 13.6057 -6.06521 34.9266 -5826 6 39.188 23.0895 28.2562 15.2318 22.185 -40.3341 -5827 4 39.2961 23.1894 27.2636 -4.5014 -1.37473 28.8386 -5828 4 38.6302 22.3345 28.3879 -14.2617 -17.3372 5.24228 -5829 6 16.9988 23.7489 0.769214 20.7079 -15.4466 5.05665 -5830 4 16.2107 23.4786 1.24898 -3.68938 2.33828 -2.20359 -5831 4 17.6949 23.1909 1.19915 -10.9726 17.7258 -9.6056 -5832 6 0.328251 33.6592 13.0294 5.05621 13.0457 -18.8804 -5833 4 55.0348 32.9975 13.677 0.78154 12.2617 9.8199 -5834 4 0.388277 34.5816 13.3997 -6.36603 -34.6234 2.68168 -5835 6 49.1005 40.6595 16.9496 -9.76098 4.73909 -13.8177 -5836 4 49.2151 40.9775 16.0207 -4.23419 -6.48803 14.4163 -5837 4 48.1506 40.7848 17.1408 8.79948 2.71791 -6.65809 -5838 6 52.1337 39.9918 15.1756 26.7545 10.0433 -2.50902 -5839 4 51.9708 40.0067 16.1202 -6.38877 -4.81519 5.40892 -5840 4 51.3465 39.7494 14.7166 -22.4824 -4.17003 -7.64187 -5841 6 29.052 37.1033 37.836 19.097 -0.968932 -4.5801 -5842 4 29.682 36.5364 38.3049 -8.87198 1.40853 -5.4338 -5843 4 28.3717 37.2982 38.474 -12.8547 4.6316 9.68073 -5844 6 4.87585 1.47991 27.5772 1.0193 4.57332 -1.4391 -5845 4 5.21258 1.06654 26.7686 1.92757 2.57678 7.5628 -5846 4 5.62617 1.67061 28.1638 -3.61661 -2.55781 -2.1886 -5847 6 43.5959 24.3463 30.211 -19.7182 -5.92862 14.3815 -5848 4 44.3514 23.9347 29.8066 13.2495 -10.0411 -7.84874 -5849 4 42.954 23.6392 30.3929 6.93549 5.0637 -4.64144 -5850 6 33.7524 3.52358 22.9355 4.65558 -3.45748 -24.1115 -5851 4 34.2253 2.7722 22.5212 -9.10678 14.6802 11.3369 -5852 4 33.6063 4.18077 22.2154 2.29559 -11.8514 17.7295 -5853 6 19.8909 13.4517 25.3922 5.25873 -5.74859 -7.9771 -5854 4 20.5096 14.0736 25.7535 5.66529 16.002 2.33546 -5855 4 19.9521 12.7313 26.0185 -3.34295 -15.2779 0.0169051 -5856 6 47.3737 23.1767 39.6212 -5.95621 11.0118 4.46955 -5857 4 47.7191 22.5265 39.0041 4.75348 -8.18234 -7.77672 -5858 4 47.7813 24.0201 39.3891 1.84918 -0.94156 0.213564 -5859 6 20.1771 18.6734 32.3906 -2.68035 -24.6067 18.319 -5860 4 19.7167 19.3347 31.8914 0.274713 15.8779 -14.5216 -5861 4 21.1289 18.7867 32.3383 1.39014 4.37005 -4.23212 -5862 6 0.462706 5.80795 25.6713 -7.84599 -7.21428 -45.242 -5863 4 0.323825 6.56383 25.0471 7.25451 -11.4554 20.6165 -5864 4 0.632949 6.14438 26.5418 1.37183 20.4375 17.7538 -5865 6 6.87393 19.55 31.9207 -32.7339 30.668 -22.5905 -5866 4 6.24577 19.9891 32.5577 15.6688 -11.8235 -17.9631 -5867 4 6.64633 19.9665 31.0139 13.7505 -20.7976 33.8805 -5868 6 6.72837 20.2799 38.5105 -3.64262 3.78431 -13.5507 -5869 4 5.92588 20.8248 38.5086 9.85336 -2.70512 -1.72466 -5870 4 6.83039 19.9897 39.4188 -3.49896 1.12624 1.5432 -5871 6 22.0356 25.927 12.2605 -11.8373 -4.76705 -8.63625 -5872 4 21.2326 25.5939 11.7351 40.6868 7.42656 16.975 -5873 4 22.8707 25.497 11.9923 -13.8486 -7.11072 -10.1952 -5874 6 39.3057 7.93299 2.64755 -0.118713 9.42534 0.0803503 -5875 4 39.6638 8.10481 3.53463 2.86319 -1.68774 -0.268253 -5876 4 39.5974 7.06378 2.35963 5.09861 -8.7519 2.38745 -5877 6 29.9647 22.0457 34.4057 2.14844 7.25734 -28.1517 -5878 4 30.9338 21.915 34.3365 -18.2911 3.03872 -0.832433 -5879 4 29.6238 22.2503 33.4865 4.56359 -4.84177 28.516 -5880 6 37.5951 16.2788 0.369586 8.64826 -19.3515 -0.400608 -5881 4 37.1939 15.3927 0.526929 9.97291 14.3398 -5.3998 -5882 4 38.4404 16.082 41.8172 -10.5319 -0.823814 4.55326 -5883 6 11.7218 13.8845 21.8896 14.7882 -39.2126 -46.5495 -5884 4 11.9305 13.3995 21.0267 -7.58848 27.5443 23.8472 -5885 4 11.7147 13.1405 22.4934 -2.11531 -1.20748 18.2217 -5886 6 33.352 10.9238 27.6262 4.19409 14.5082 -21.7958 -5887 4 32.741 11.5866 27.2704 3.79692 -6.80494 8.02232 -5888 4 34.0591 10.8732 26.9373 -11.2958 -2.76298 18.1193 -5889 6 30.9422 36.5217 10.1011 0.546516 -38.0529 -7.53065 -5890 4 31.037 36.4313 9.10316 -3.7795 -1.86296 33.6151 -5891 4 30.9555 35.5897 10.5034 1.2522 32.9448 -19.5962 -5892 6 45.5828 6.56917 25.2425 13.4794 -38.3135 -0.0969536 -5893 4 44.6735 6.51564 25.4913 -20.1668 12.9455 3.79285 -5894 4 45.8221 5.605 25.2656 2.31227 28.4662 -4.04899 -5895 6 9.53612 30.0233 12.041 13.8898 -20.9008 -19.4413 -5896 4 9.92894 30.5763 11.3437 -1.97905 0.820167 2.98642 -5897 4 9.13364 30.6129 12.6538 -15.721 17.9312 16.9413 -5898 6 53.0747 24.9738 1.38132 -1.86355 2.7084 19.7503 -5899 4 52.7154 24.2509 0.898374 -13.0694 -24.4059 -9.99565 -5900 4 53.2522 25.5795 0.686793 9.94881 23.634 -11.856 -5901 6 26.1984 24.7352 0.509304 -7.53082 -0.727442 -26.3589 -5902 4 25.609 24.783 41.6367 17.1237 -12.5609 6.929 -5903 4 25.7967 25.3842 1.06587 -1.32139 13.3231 25.2347 -5904 6 23.0109 2.41889 11.5345 -1.81733 -0.917938 -19.7561 -5905 4 22.156 2.16845 11.9124 1.98231 0.963836 1.10425 -5906 4 22.831 2.471 10.5696 1.38956 0.195961 11.1121 -5907 6 29.9165 12.8947 31.0013 41.0722 8.15666 -12.068 -5908 4 30.8272 12.8901 31.3843 -23.6061 -3.22469 3.62361 -5909 4 30.1671 13.0589 30.0659 -21.5099 -4.3955 11.2257 -5910 6 24.0423 16.1922 40.3682 -11.7161 -52.7791 -12.7633 -5911 4 23.7963 16.7427 41.0863 -4.03022 37.1909 22.8519 -5912 4 24.4513 16.6836 39.6566 3.29428 17.0417 2.56802 -5913 6 21.8759 29.9137 12.7377 16.7673 9.38207 5.68416 -5914 4 21.0615 29.603 12.3447 -12.732 2.54077 -5.12984 -5915 4 21.8572 30.8889 12.7388 -3.49843 -10.2696 0.0943897 -5916 6 45.2049 12.2865 6.6319 2.92472 30.2037 5.62675 -5917 4 45.4908 11.5347 6.14771 0.0808414 -27.1796 -10.0093 -5918 4 45.9331 12.9133 6.49804 -8.49251 3.31449 4.74769 -5919 6 7.58748 25.3948 38.035 37.4402 -5.69153 16.1754 -5920 4 8.20159 25.1941 37.2709 -20.479 6.14302 24.9331 -5921 4 8.13335 25.2556 38.8857 -20.6102 5.92378 -35.7711 -5922 6 46.1732 7.83303 16.6988 4.4841 14.5494 -17.535 -5923 4 46.5452 7.84101 15.8027 -9.24205 10.2202 -0.760543 -5924 4 46.6945 7.14485 17.0776 9.771 -19.5689 22.069 -5925 6 54.9675 12.85 7.71106 -14.5426 11.3809 9.40253 -5926 4 54.9732 13.8139 7.75484 8.59467 -0.566973 -8.90089 -5927 4 54.3786 12.658 8.45528 8.25441 -10.7611 -5.52346 -5928 6 26.93 39.6729 37.1759 35.4319 -17.0193 24.0328 -5929 4 27.7049 39.4447 36.6239 -16.3058 8.04164 -6.8945 -5930 4 27.2164 39.2553 38.0316 -23.1866 12.5553 -17.3208 -5931 6 27.0277 8.92497 38.0115 25.8258 -15.1538 -19.4143 -5932 4 26.3205 9.53863 38.1727 -14.2244 17.8778 -0.0983549 -5933 4 27.5327 9.26244 37.2322 -14.307 -2.33761 14.5508 -5934 6 8.04621 7.65921 29.9125 5.96085 -8.8046 12.0925 -5935 4 8.66182 7.92407 30.6202 -6.26406 -0.422529 -8.96361 -5936 4 7.80891 8.46925 29.4702 -0.676119 14.2 -7.80782 -5937 6 27.8751 27.8625 12.1001 -31.3933 22.4686 19.454 -5938 4 27.5095 28.719 12.4446 7.36494 -19.3603 -4.77408 -5939 4 28.6439 28.079 11.5991 25.5597 3.40516 -15.3306 -5940 6 23.5464 30.4867 38.1533 -1.61625 -6.62341 9.61758 -5941 4 24.0833 30.8354 38.8715 -5.37174 -4.61911 9.80189 -5942 4 23.9933 30.8636 37.4157 3.53805 3.96797 -22.0348 -5943 6 48.0805 24.2983 17.323 -13.282 16.609 -1.2587 -5944 4 47.4189 24.8263 17.8481 20.4082 -10.1323 -14.146 -5945 4 48.1392 24.7467 16.448 -1.93384 -6.90404 13.1726 -5946 6 38.5137 5.30503 40.3397 -7.95418 19.3032 15.6478 -5947 4 38.8605 4.51762 39.8919 14.9068 5.60332 0.485922 -5948 4 39.0782 6.12858 40.3573 -2.94219 -25.5867 -8.28862 -5949 6 31.2334 3.92786 33.7298 9.31662 9.08835 -13.8199 -5950 4 31.8178 4.24357 33.0198 -6.00608 1.6224 5.38661 -5951 4 31.5957 3.05883 33.9262 -1.57661 -10.2527 7.73336 -5952 6 41.2417 8.81323 38.1247 -0.484904 -12.0607 11.4744 -5953 4 40.9476 8.42023 38.9721 -0.376638 9.54125 -7.13918 -5954 4 41.2604 9.77162 38.2616 1.58028 -2.03482 4.89657 -5955 6 53.3602 29.1001 24.587 -11.0956 7.72569 2.80506 -5956 4 52.5731 28.5594 24.8544 13.5868 20.3826 -7.54714 -5957 4 53.0545 29.9696 24.221 1.09296 -21.6534 7.27768 -5958 6 54.9204 15.5334 40.7094 -9.73888 -15.8123 9.62316 -5959 4 54.8689 16.4143 40.4003 18.499 35.235 -15.9181 -5960 4 53.9936 15.418 40.9228 -4.36807 -19.1537 6.40504 -5961 6 46.4046 17.0769 31.8825 -4.88415 8.61979 -0.317809 -5962 4 46.5643 17.9902 31.5503 -4.54791 -14.0743 0.407713 -5963 4 45.6863 16.6828 31.3336 12.87 12.2001 8.08584 -5964 6 36.9136 25.0502 23.0508 4.56287 5.14957 -21.3849 -5965 4 37.1181 25.0639 23.9643 8.53293 7.7605 31.6671 -5966 4 36.2092 24.4176 22.9617 -10.0712 -5.98832 -5.36051 -5967 6 11.3786 4.43396 15.9309 9.37238 17.2608 -3.05203 -5968 4 11.3458 3.5794 15.4688 2.43716 9.1998 0.97888 -5969 4 11.7026 5.12247 15.2999 -5.70859 -16.4138 5.77914 -5970 6 12.7896 7.06818 19.4525 -2.66824 36.6483 10.7184 -5971 4 12.9865 6.29411 18.9417 0.495259 -24.323 -4.17525 -5972 4 12.2519 6.828 20.2299 7.04203 -8.59773 -13.3487 -5973 6 12.0617 33.6499 17.5439 8.15138 -13.8576 -23.5514 -5974 4 11.882 34.0654 18.3682 -11.1792 16.7137 24.4072 -5975 4 12.5902 32.8825 17.8108 -1.08307 -0.300652 -3.52071 -5976 6 10.2421 4.75805 2.56564 19.3085 -11.8452 1.86691 -5977 4 9.45693 4.42703 2.99801 -10.4664 -1.42643 2.59081 -5978 4 10.9264 4.04527 2.68225 -6.18235 16.1727 -3.70264 -5979 6 4.57251 36.8735 12.1563 3.74049 -23.6741 -21.1206 -5980 4 4.47996 37.7154 12.5491 -11.9533 34.2042 20.255 -5981 4 5.43811 36.9355 11.7449 0.921031 -10.3689 -0.351167 -5982 6 30.7412 35.3317 25.8213 -33.1423 -23.543 6.44877 -5983 4 31.2776 35.279 26.6136 10.5944 3.70967 -1.00248 -5984 4 29.9668 34.7615 26.0677 13.1622 11.7399 -12.7178 -5985 6 20.1808 7.16217 1.863 30.1084 16.4868 -11.867 -5986 4 20.9002 6.54767 2.16414 -16.0511 17.5979 -8.58506 -5987 4 20.6676 7.94845 1.45686 -14.4541 -29.1822 13.3394 -5988 6 21.7608 6.89709 28.9964 -11.5861 -1.80466 -8.03013 -5989 4 22.036 7.16072 29.8728 6.26891 1.69864 13.9065 -5990 4 22.5393 6.5849 28.5353 8.83449 0.101288 -1.59126 -5991 6 6.87368 37.1369 6.9386 0.0966708 26.3677 27.0276 -5992 4 7.29364 38.0249 6.81033 -7.58004 -19.2864 -7.26696 -5993 4 6.61926 37.1727 7.88431 1.83825 -7.02501 -19.6681 -5994 6 37.1919 18.383 16.2937 29.0289 34.5069 -53.2335 -5995 4 36.6258 18.6038 17.011 -19.1901 14.6481 22.2869 -5996 4 37.3395 19.2625 15.7718 -11.4936 -34.1346 27.3139 -5997 6 52.3871 25.4845 31.3088 43.0013 26.9533 24.6388 -5998 4 52.3889 26.4071 31.692 -12.9868 -26.5619 -15.078 -5999 4 53.3562 25.2868 31.368 -25.5563 -9.18093 -7.26498 -6000 6 3.9438 39.8542 16.3866 5.1752 -27.5036 1.27902 -6001 4 3.12325 39.6837 16.8533 -2.95342 6.97088 0.658243 -6002 4 4.2268 38.9387 16.1321 1.7457 31.291 -0.663648 -6003 6 26.0576 14.6358 18.3044 5.96149 26.4073 -5.45028 -6004 4 27.0205 14.6227 18.4365 -6.17521 2.0803 0.6884 -6005 4 25.8163 15.5963 18.2277 1.60591 -22.5499 1.70317 -6006 6 22.193 39.6312 23.63 -9.05536 -28.9999 9.83005 -6007 4 22.6639 40.3889 23.3083 10.2118 22.7493 1.36107 -6008 4 21.7625 39.8434 24.4837 8.53947 8.47814 -10.8223 -6009 6 5.99591 12.8758 22.3742 5.3436 -0.661706 -0.190442 -6010 4 6.14325 13.1833 21.4713 -0.679137 1.38292 -0.893953 -6011 4 6.87425 12.6139 22.6767 3.78948 -2.07704 1.05968 -6012 6 48.9338 28.1628 34.7078 -35.8712 26.2385 4.15493 -6013 4 48.201 27.5556 34.4701 19.6025 -0.265843 1.21851 -6014 4 49.8217 27.8183 34.7001 12.2446 -20.4038 -3.75147 -6015 6 7.76997 22.4407 33.2353 -5.03116 -11.9457 7.57841 -6016 4 8.01899 22.0009 34.0594 5.33952 7.11928 -2.86974 -6017 4 7.10669 21.8538 32.8613 -1.17853 4.26119 -2.40878 -6018 6 41.0955 39.6222 11.7091 10.6381 -27.5326 3.52715 -6019 4 40.5189 40.2602 11.288 0.0449404 21.7474 -0.525631 -6020 4 41.8612 39.9918 12.1934 -14.1016 15.1893 -9.59654 -6021 6 26.8828 37.915 39.359 -2.28209 0.567193 11.8658 -6022 4 27.0774 38.1179 40.3058 -8.7685 -4.90824 -13.677 -6023 4 25.9807 37.5277 39.3071 12.6176 5.79057 5.20946 -6024 6 16.8333 41.5427 16.7885 -17.5694 -7.84814 -1.75502 -6025 4 17.5277 0.148354 16.3589 5.69783 -2.62712 11.3029 -6026 4 16.9979 41.3393 17.726 8.37907 5.88226 -10.2657 -6027 6 19.018 8.99657 17.6669 -0.857073 -13.2853 32.8939 -6028 4 18.786 9.90902 17.9004 1.19423 -0.949069 -3.8378 -6029 4 19.1413 8.47286 18.5173 -2.13518 15.132 -32.6231 -6030 6 31.1034 24.3848 20.0884 -4.53251 11.7336 -2.81937 -6031 4 30.5766 24.6463 20.8643 6.13742 -4.20791 -6.36966 -6032 4 31.7352 25.0989 19.9557 0.422515 0.146513 0.562515 -6033 6 24.595 6.30881 27.6069 -9.90555 -11.0232 -14.6341 -6034 4 24.6965 6.6392 26.7007 0.89989 8.76246 8.56835 -6035 4 24.5083 5.35606 27.4824 0.344086 -1.65377 9.53776 -6036 6 11.6335 5.32908 8.21523 29.3959 14.5761 -12.3078 -6037 4 10.744 5.12885 8.4339 -32.4949 -9.42488 11.9016 -6038 4 11.5648 6.10082 7.62627 0.276207 -9.77668 5.48929 -6039 6 16.478 34.2375 17.2464 48.0037 -1.61779 7.84119 -6040 4 15.7306 34.6529 16.8034 2.48832 11.605 -8.49411 -6041 4 17.405 34.6677 17.061 -56.7063 -17.2336 2.19282 -6042 6 40.7477 40.4696 8.51561 8.11488 -8.65224 -15.2287 -6043 4 40.0224 40.6832 9.09702 -8.50867 2.70994 6.70857 -6044 4 40.4514 39.6579 8.0617 2.3787 8.8385 5.97324 -6045 6 42.7444 5.87231 14.2984 24.2128 7.61876 -1.56509 -6046 4 42.0757 5.96647 14.9632 -14.4615 -1.80987 8.42029 -6047 4 42.482 5.17586 13.6922 -11.2697 -3.69634 -0.0191913 -6048 6 14.3614 21.0573 6.06698 -40.3301 2.02826 20.3099 -6049 4 14.5082 21.6099 6.85229 1.25225 -5.13952 -5.68983 -6050 4 15.1941 20.9025 5.67555 35.2665 -1.55979 -15.977 -6051 6 16.3015 37.7733 18.121 -25.7671 9.10936 -15.4408 -6052 4 15.381 38.1761 18.2458 41.2545 -15.1679 7.93486 -6053 4 16.7788 37.6858 18.9587 -11.1023 5.71932 1.62274 -6054 6 40.7984 27.7161 27.1129 -11.0179 0.499807 -0.336913 -6055 4 41.4742 27.2927 27.66 5.56711 1.79851 -1.75817 -6056 4 41.2133 28.334 26.4954 6.67104 -1.0644 4.19578 -6057 6 44.9561 25.991 14.0487 25.7727 -16.7938 -19.0088 -6058 4 45.3739 25.1637 13.7108 -16.5098 12.8855 15.8726 -6059 4 45.5476 26.6442 13.6478 -7.0093 2.51014 3.36733 -6060 6 2.61494 33.9473 21.2474 -9.6198 2.06317 -4.83635 -6061 4 2.13704 34.7904 21.3802 4.44423 -7.12162 -0.559399 -6062 4 2.10703 33.4352 20.5879 2.52794 8.8644 7.26413 -6063 6 5.77575 4.45209 12.8318 1.03208 18.7287 8.08797 -6064 4 5.35339 3.69685 13.2518 -3.06112 -10.1665 -2.69945 -6065 4 5.8052 5.15326 13.507 0.887863 -7.02627 -5.52828 -6066 6 16.8649 5.92112 7.40874 19.9951 -5.29142 4.66315 -6067 4 16.4994 5.07825 7.12483 -4.58221 -9.71617 -5.56506 -6068 4 16.109 6.48147 7.52662 -16.4719 8.95214 3.19539 -6069 6 17.8298 38.4233 36.8534 9.258 40.3096 -0.310058 -6070 4 17.7926 39.4131 36.8935 -6.04129 -19.7424 1.84578 -6071 4 18.5177 38.2893 36.201 1.93535 -10.8086 -1.92368 -6072 6 43.3019 20.5959 5.44166 -6.9278 5.85438 -3.52603 -6073 4 43.1055 21.501 5.07158 -2.97833 -26.833 8.04502 -6074 4 42.4661 20.0651 5.41852 11.3272 16.2867 -2.99003 -6075 6 21.5372 23.2991 30.4448 -14.935 11.2275 -26.3705 -6076 4 20.9947 23.0537 31.1809 -7.12546 -6.28648 20.8256 -6077 4 20.8648 23.582 29.7655 22.6032 -4.28693 10.3415 -6078 6 0.251317 28.0486 36.1651 -22.0243 21.0356 -19.5016 -6079 4 1.02049 27.7114 36.6113 18.9729 -1.47718 6.47801 -6080 4 0.506474 28.8456 35.6445 2.58205 -12.8812 9.00708 -6081 6 3.04678 17.0589 11.5707 1.23946 -7.00965 -18.5436 -6082 4 3.14519 17.2619 12.4977 -1.89892 8.1653 13.6088 -6083 4 2.54959 17.7766 11.1613 1.73961 1.36316 5.23635 -6084 6 24.1645 37.0333 23.9496 -13.0802 10.7124 17.6799 -6085 4 23.6099 37.8384 23.8849 6.1763 -9.33563 -1.28122 -6086 4 24.4663 37.0147 24.8893 -3.58635 -1.49958 -18.3056 -6087 6 3.94341 20.5209 27.4789 6.12038 36.4957 26.1587 -6088 4 3.64002 20.0757 26.7101 -13.0247 -10.3927 -30.3524 -6089 4 3.8213 21.4921 27.3096 0.6263 -21.942 -1.90407 -6090 6 54.8381 2.78983 29.6272 25.3782 12.002 29.7256 -6091 4 54.8259 2.49183 30.5832 -3.08894 8.50949 -25.0172 -6092 4 0.681738 3.33643 29.5869 -23.0163 -14.7319 0.890579 -6093 6 27.1738 8.43221 31.7209 4.37325 44.8318 10.1666 -6094 4 26.7765 8.21235 30.8513 3.34031 12.9925 0.247925 -6095 4 27.4394 9.43578 31.8184 -18.7706 -51.1708 -12.8964 -6096 6 30.9422 1.62815 30.3909 7.68258 9.19266 14.5116 -6097 4 30.6848 0.902997 29.8247 -17.6873 -14.6962 -9.63211 -6098 4 30.1385 1.96768 30.8202 -2.70664 -9.08975 -4.26502 -6099 6 26.4126 36.4396 36.8407 14.7094 2.78685 2.16538 -6100 4 26.1754 35.936 36.0621 -1.37556 -1.6634 -9.1832 -6101 4 27.3614 36.6667 36.7609 -11.9856 -2.56278 0.470716 -6102 6 51.3051 10.055 21.7064 16.9271 -12.7171 -0.47742 -6103 4 50.71 9.38094 22.0984 13.3581 11.7028 -6.50503 -6104 4 52.1297 9.58932 21.3894 -28.6693 12.5934 9.83408 -6105 6 52.4269 12.3712 23.2743 -6.4707 23.0639 13.1163 -6106 4 51.7645 13.1043 23.2119 13.6159 -11.3613 1.42096 -6107 4 52.024 11.6223 22.842 -6.69009 -13.0182 -9.76131 -6108 6 10.0084 38.37 20.6075 21.9453 -2.41338 -4.30271 -6109 4 9.45069 38.2813 21.3825 -6.19229 -0.201962 6.85596 -6110 4 10.9137 38.1225 20.8794 -8.5598 0.614521 -3.9406 -6111 6 22.7031 33.2664 0.640708 10.9794 6.62646 4.85135 -6112 4 23.6679 33.2996 0.582378 1.56947 7.5672 2.73741 -6113 4 22.5144 32.4288 0.230474 -14.5468 -15.5809 -6.04383 -6114 6 14.0917 40.8812 25.4864 9.18744 8.89463 -14.7226 -6115 4 14.196 40.6884 26.4283 -5.63746 -5.20078 0.271339 -6116 4 13.2439 40.5125 25.1796 5.27736 1.6069 9.18822 -6117 6 42.7681 15.0783 14.9763 7.15748 5.71054 -2.59845 -6118 4 43.0785 15.7158 14.2901 -5.10451 -16.9901 16.8665 -6119 4 41.8327 15.2592 15.1092 -5.54173 -0.124331 1.80857 -6120 6 30.2406 7.22111 8.53832 -0.545825 26.9265 -4.64375 -6121 4 30.1758 8.19473 8.52708 -1.1145 -9.52086 -16.9196 -6122 4 30.4024 7.07989 9.45321 5.06633 -17.0605 24.2519 -6123 6 3.37759 19.8423 41.3077 23.4194 0.89426 -0.123069 -6124 4 3.19865 19.3681 40.4829 0.842743 3.23829 1.04749 -6125 4 4.34953 20.0012 41.2688 -20.407 -4.57585 2.1738 -6126 6 8.87423 25.1354 17.2017 -10.0567 -4.23249 -18.7298 -6127 4 8.96932 24.947 16.2256 5.94886 2.92938 28.6011 -6128 4 9.65182 24.8278 17.6915 0.0257745 -5.63434 -9.64419 -6129 6 9.32494 14.9555 22.0283 -12.5325 4.5599 7.62514 -6130 4 9.01993 14.8718 22.9489 -0.27625 1.365 -7.1979 -6131 4 10.1958 14.5523 22.0148 2.38734 -2.44115 -2.54227 -6132 6 2.03086 4.7751 20.8592 -0.302533 -25.5342 -8.8148 -6133 4 2.76807 5.37577 20.9697 7.90436 11.3601 5.00545 -6134 4 1.2576 5.15949 21.2703 -7.54078 11.376 6.7073 -6135 6 18.2964 7.06718 3.86051 -0.633466 1.54328 39.8902 -6136 4 18.916 7.22135 3.16498 20.2468 5.35447 -22.1173 -6137 4 18.8081 6.54637 4.52758 -12.8964 10.087 -8.61721 -6138 6 17.0178 19.1734 19.8425 8.05121 8.342 4.19715 -6139 4 17.786 18.9037 19.3194 -9.06534 -4.96345 -2.22737 -6140 4 16.269 18.585 19.6427 11.1227 0.819232 -3.01639 -6141 6 4.30363 6.55267 21.3463 7.67654 -0.43578 -3.38259 -6142 4 4.33009 7.06923 20.5107 4.36212 -5.74714 10.2686 -6143 4 5.22777 6.26626 21.5669 -20.6993 9.2157 -12.5452 -6144 6 20.7848 36.9284 35.662 4.03453 1.95325 3.7669 -6145 4 20.2254 37.0836 34.8976 -2.25577 1.87165 -3.27163 -6146 4 20.2383 36.4327 36.2875 0.848364 -0.11832 4.44878 -6147 6 4.7306 15.0205 31.2333 -1.91968 -20.8619 8.65585 -6148 4 4.4229 14.7734 32.1398 6.18773 10.2906 -17.1472 -6149 4 4.73385 15.973 31.1263 -2.35963 8.87481 4.31723 -6150 6 2.35358 1.22877 17.5767 10.9459 -8.92502 -6.22121 -6151 4 3.05741 1.28614 16.8672 -19.772 5.07478 19.7417 -6152 4 1.94409 2.09607 17.7592 7.86728 -5.07336 -5.26938 -6153 6 34.6221 31.5613 19.8029 0.0167231 -1.91103 -0.857839 -6154 4 35.0026 31.8698 18.9629 1.12657 -3.13716 4.28436 -6155 4 34.4223 32.3623 20.3103 -0.485441 0.265221 -3.01806 -6156 6 24.1912 21.6103 13.5173 31.6251 8.72647 13.7111 -6157 4 25.0921 21.8731 13.8418 -25.6554 -7.43575 -12.369 -6158 4 23.5893 22.1875 13.984 -2.65104 7.77201 2.87587 -6159 6 37.2187 41.0834 5.69361 1.76676 -13.0415 -0.936073 -6160 4 37.8761 41.7354 5.91144 16.7665 3.57334 0.125879 -6161 4 36.4089 41.5349 5.88363 -19.4064 5.82624 -1.33385 -6162 6 8.4323 8.00063 20.2395 28.2224 -17.334 -6.20124 -6163 4 9.29892 8.115 20.6547 2.73811 -3.60152 -0.447724 -6164 4 7.94828 8.69862 20.6224 -29.3938 29.4062 12.6481 -6165 6 14.9357 18.8843 36.7618 11.8158 33.7978 0.271425 -6166 4 14.1259 19.2123 36.362 -3.40669 -6.42507 -0.135577 -6167 4 15.5651 19.6361 36.6422 -7.52364 -17.7077 5.06346 -6168 6 43.9725 40.6444 18.6569 4.16672 -2.33153 16.0012 -6169 4 43.9166 40.834 17.7203 0.682613 4.51617 -13.4207 -6170 4 44.9212 40.6761 18.9032 -12.0211 -3.47257 -3.21486 -6171 6 33.7852 32.2494 37.3449 -11.8504 2.76306 -14.1758 -6172 4 34.0177 32.2775 36.4055 -1.41242 -0.232407 11.1732 -6173 4 34.3686 31.6236 37.7745 10.7747 -2.06792 3.13276 -6174 6 5.09749 29.2901 24.0356 16.7213 -6.5526 19.7529 -6175 4 5.77222 29.487 24.7328 -11.5239 -2.29901 -14.2657 -6176 4 4.7684 30.1321 23.7215 -1.73734 11.0072 -2.10513 -6177 6 33.6153 36.4198 10.9805 1.47517 3.52666 5.33615 -6178 4 32.7579 36.4403 10.5596 -3.06779 3.10292 -7.60642 -6179 4 33.384 36.4828 11.91 5.71512 -0.747971 7.16991 -6180 6 28.3006 33.5952 13.1115 6.62888 -15.4249 13.7129 -6181 4 27.948 33.7778 12.2398 -4.56551 -8.24283 -4.77521 -6182 4 28.1705 32.6462 13.2914 -0.364449 12.3294 -7.26248 -6183 6 6.16378 19.058 24.2919 3.99573 -9.29146 -27.7059 -6184 4 6.01812 19.825 24.8144 -3.49512 27.1397 16.8881 -6185 4 6.29927 18.3335 24.8859 3.7649 -20.2974 16.0908 -6186 6 28.4267 19.9356 1.8581 6.30761 1.98196 1.30153 -6187 4 28.5945 19.3745 1.10227 -2.74725 -9.675 -9.29711 -6188 4 29.2893 20.1184 2.23075 1.76934 5.71608 2.57016 -6189 6 42.0557 23.969 9.55925 -0.174378 -1.97525 4.49576 -6190 4 42.3037 23.8044 10.4694 5.92504 9.79373 11.5418 -6191 4 41.7282 23.1152 9.29053 -8.19873 -12.6145 -11.7634 -6192 6 43.5187 7.30226 27.4319 7.08124 -12.3985 0.368771 -6193 4 42.7424 7.14751 27.9838 -5.23639 1.01312 3.8871 -6194 4 43.2552 7.97753 26.8025 -4.71413 8.37143 -8.21745 -6195 6 20.4824 33.0041 9.27291 -32.573 -27.3267 34.6611 -6196 4 19.7824 32.5876 9.93875 35.2414 32.5831 -36.6535 -6197 4 20.3431 33.9616 9.1663 -10.2228 -2.75758 9.24016 -6198 6 38.0326 35.2526 15.9362 -7.94884 -19.6622 -5.99631 -6199 4 37.3459 34.9971 15.2894 4.63074 2.95951 5.93375 -6200 4 37.9463 34.6017 16.6504 2.45283 5.99568 -2.76115 -6201 6 47.5301 20.8853 3.96175 -5.34824 -5.66637 20.3565 -6202 4 47.9759 21.3648 3.2498 -4.9297 7.97101 8.48596 -6203 4 47.5029 21.3928 4.81786 6.75175 -1.3172 -26.6206 -6204 6 10.9933 31.6966 41.4271 11.47 5.02521 -0.853614 -6205 4 11.6392 31.7665 40.7132 0.112137 -5.28149 3.10577 -6206 4 10.1353 31.6993 40.998 -8.62143 -0.203152 -1.66696 -6207 6 43.2403 12.6562 2.57215 9.62694 -8.68348 -18.5989 -6208 4 42.9077 12.993 3.39384 -2.38679 2.43178 19.528 -6209 4 44.033 12.1261 2.78242 -8.9232 8.2725 3.71991 -6210 6 49.4204 25.4105 21.1683 5.59269 -12.2048 -2.72561 -6211 4 50.0196 25.2987 20.4097 -7.64964 4.29225 2.01473 -6212 4 48.8877 24.5919 21.195 1.69169 7.44836 1.02425 -6213 6 1.95674 34.1403 26.4747 8.8762 -24.2704 6.47661 -6214 4 2.77674 33.6103 26.5537 -12.4269 14.6955 -4.62849 -6215 4 1.26657 33.4613 26.3994 -1.21739 9.31774 -1.03397 -6216 6 17.1306 20.8229 36.6851 -31.9931 14.1441 13.8122 -6217 4 16.9533 21.7471 36.9985 5.62896 -19.6931 -5.93312 -6218 4 18.0634 20.696 36.5868 23.783 -2.64609 -3.70934 -6219 6 36.6048 10.9866 3.71548 -5.44552 8.31799 24.2539 -6220 4 35.7423 11.3886 3.87785 -5.6936 5.55042 -13.8219 -6221 4 36.8135 10.7077 4.61447 10.9535 -7.59336 -0.361553 -6222 6 14.2169 20.6838 21.9439 11.6961 23.12 -6.3106 -6223 4 13.8085 20.2376 21.1912 1.98746 8.13024 -7.83415 -6224 4 14.8103 21.4259 21.6461 -14.674 -27.097 -1.82439 -6225 6 33.9151 12.2544 9.54899 39.8857 -26.0408 -21.0892 -6226 4 34.3088 11.5163 10.0208 11.0461 -3.70138 -11.6499 -6227 4 33.2997 12.4814 10.1903 -47.9458 31.9244 32.2008 -6228 6 21.8056 41.4836 2.15686 0.64336 -1.87746 -8.80618 -6229 4 22.0354 41.6672 1.22189 -5.57638 1.91412 12.8342 -6230 4 22.5122 40.9391 2.50884 5.16687 -0.375256 0.644554 -6231 6 20.9282 10.4547 14.1996 25.019 -0.0729632 25.5582 -6232 4 21.5922 10.842 14.8375 -21.0894 -6.80718 -21.5316 -6233 4 20.826 9.54084 14.5456 -0.887825 12.9084 -9.51249 -6234 6 6.24616 4.45231 24.6293 -10.9468 0.993291 2.39826 -6235 4 6.83688 4.17894 23.9311 12.242 -0.137787 -14.9911 -6236 4 5.68087 3.68408 24.7586 -3.59028 -1.51582 -1.5433 -6237 6 50.784 14.5954 23.4824 21.8736 9.84292 5.60122 -6238 4 51.2681 15.1205 24.1582 -9.03857 -7.6656 -10.4761 -6239 4 49.9341 14.3608 23.8519 -7.60536 -4.54693 6.65168 -6240 6 52.7678 13.9144 9.68214 -3.90955 36.1598 -0.40974 -6241 4 52.8738 13.0144 9.92216 4.47335 -34.5538 7.53363 -6242 4 51.8729 14.0092 9.35938 -14.036 0.105332 -6.17221 -6243 6 9.05048 2.05234 29.9152 -29.3842 -12.1538 -14.6176 -6244 4 9.42756 2.83336 30.2687 13.3628 24.1087 13.7335 -6245 4 8.09173 2.26823 29.8032 18.9866 -6.39081 0.174186 -6246 6 7.13499 29.9757 26.2377 7.52656 -33.046 2.78556 -6247 4 6.52748 30.39 26.8607 -0.20976 -1.88395 4.87081 -6248 4 7.49713 29.1538 26.6869 -11.4544 24.9502 -11.4644 -6249 6 49.1541 41.742 14.3355 11.4439 21.5488 -10.6063 -6250 4 49.5333 41.2573 13.5835 -2.72613 -5.13007 3.47372 -6251 4 49.526 0.750494 14.2401 -8.50163 -23.9907 2.80869 -6252 6 5.64545 3.82333 19.1929 -5.43924 -10.1162 19.2647 -6253 4 5.12472 3.39384 19.906 6.51959 7.46947 -11.8792 -6254 4 5.07872 3.8651 18.4273 -3.31865 2.78603 -7.74707 -6255 6 9.32747 35.8381 24.9081 -3.67476 7.0144 6.61099 -6256 4 10.2167 35.7622 24.5243 -1.5306 1.39279 3.84516 -6257 4 9.42305 36.4736 25.6393 1.10498 -0.920313 -3.33942 -6258 6 53.0258 29.7567 11.5493 -1.29773 -2.97991 8.71205 -6259 4 53.4398 30.4104 10.9769 2.6525 4.63524 -3.89524 -6260 4 52.8324 30.2122 12.386 1.27544 -1.91261 -4.55584 -6261 6 22.6082 9.97702 5.69106 1.45951 -2.04334 43.7981 -6262 4 23.4598 10.2484 6.09617 -7.85329 -3.83944 -13.5574 -6263 4 22.5497 10.2693 4.79236 2.60512 5.60546 -21.7219 -6264 6 39.5532 19.6216 2.68726 -3.50035 -14.5445 -22.3968 -6265 4 38.6563 19.3067 2.54039 -1.65167 0.121811 17.9309 -6266 4 39.9003 19.405 1.80953 18.3116 7.78412 6.67062 -6267 6 45.082 35.5833 7.81025 20.3465 -2.3491 -25.2688 -6268 4 45.1219 36.3229 8.40611 -5.73741 11.9797 15.8104 -6269 4 44.452 34.9332 8.12016 -12.4923 -3.86067 9.83054 -6270 6 29.7976 14.244 9.96067 -5.32248 -4.64296 1.12628 -6271 4 30.0443 14.0971 9.02808 -4.18819 -1.64606 2.67632 -6272 4 28.8444 14.0269 10.0606 18.5465 4.64021 -4.02524 -6273 6 29.2523 30.155 21.8932 -5.77992 6.30922 3.94049 -6274 4 29.1431 30.8143 21.21 -7.42967 10.4849 -3.0507 -6275 4 30.0153 29.6632 21.6201 11.6336 -14.2167 -2.13367 -6276 6 11.1107 18.8213 6.56056 -14.6836 -1.88929 0.635516 -6277 4 11.166 19.7501 6.27543 7.98891 -2.6539 -0.194038 -6278 4 11.9915 18.4225 6.59495 6.41359 9.14832 -2.51569 -6279 6 13.4142 39.1371 13.4638 17.7807 -10.3765 -23.6259 -6280 4 13.7831 39.7975 14.0449 5.16656 9.87024 9.85065 -6281 4 12.6066 38.8468 13.8734 -16.0883 -5.26763 6.93978 -6282 6 50.1521 12.9948 0.13749 23.7903 11.3983 42.7862 -6283 4 49.8531 12.6437 41.2486 -17.3674 -16.2897 -43.7514 -6284 4 50.6811 12.2823 0.528204 -2.61001 5.26075 1.59628 -6285 6 47.8279 31.3538 27.7873 0.535952 -14.579 -21.2406 -6286 4 47.8981 31.8966 28.5732 -11.876 9.28639 5.42067 -6287 4 46.9879 31.5201 27.3031 12.1261 3.81279 14.9113 -6288 6 27.708 1.63283 7.49454 14.1634 -3.44528 -21.3886 -6289 4 26.9442 1.71926 8.04828 -16.4795 3.87106 10.0363 -6290 4 27.4331 1.03137 6.77318 -2.44435 3.14912 6.58235 -6291 6 54.8843 20.7912 16.041 -0.591057 -23.5277 -19.4313 -6292 4 54.9506 20.9946 16.9763 2.49267 -3.51754 11.2958 -6293 4 0.215527 19.8591 15.8725 -6.64294 24.8159 10.1677 -6294 6 37.4309 32.9919 34.4461 -3.01999 17.5498 0.613574 -6295 4 37.2599 32.074 34.6492 -8.98721 -14.1314 1.69718 -6296 4 36.602 33.3843 34.0789 10.8556 -9.90957 7.57788 -6297 6 19.516 39.775 6.74949 1.2991 -23.719 -0.568837 -6298 4 19.1628 39.2461 5.9771 11.6696 10.1577 21.4746 -6299 4 19.8715 39.1258 7.41882 -10.6166 14.587 -19.1486 -6300 6 32.439 2.74298 8.0597 2.15016 14.1028 28.0311 -6301 4 32.8474 3.04427 8.91221 -2.20578 -4.83758 -21.9226 -6302 4 31.6043 2.37221 8.38063 -2.27075 -4.50389 -9.9889 -6303 6 12.9757 16.0783 4.05517 0.782156 -17.4841 -11.0101 -6304 4 12.5393 15.6612 4.81952 2.97976 0.136191 -5.67644 -6305 4 13.3707 15.3387 3.55371 -3.64889 7.0956 8.52646 -6306 6 4.65115 29.9533 5.41887 4.80886 14.2508 -32.4371 -6307 4 5.0407 30.2031 4.52094 -17.5959 -12.1853 28.663 -6308 4 3.95879 29.263 5.26663 23.43 17.9812 0.878069 -6309 6 29.754 32.1152 24.0535 7.2798 7.01713 3.37681 -6310 4 30.6602 32.1649 24.4187 -11.1956 -0.828668 -6.39664 -6311 4 29.7572 31.4388 23.3746 -2.03067 -7.97912 -3.55015 -6312 6 11.8649 30.6972 33.4692 4.66278 -43.8766 26.3819 -6313 4 11.8723 29.8544 34.0435 -6.78391 38.5593 -23.2698 -6314 4 12.7601 30.7129 33.1118 -0.162199 2.5806 0.32685 -6315 6 17.3589 40.4121 27.3072 22.6925 26.1242 -9.80885 -6316 4 17.3318 41.3765 27.4299 10.8839 -2.3351 -5.50809 -6317 4 16.5554 40.1462 27.6883 -41.5002 -17.3681 16.6281 -6318 6 8.67113 4.89706 8.92484 12.0335 -9.87957 -4.1983 -6319 4 8.33733 5.39218 8.1724 -5.0195 2.6367 -1.72337 -6320 4 8.22391 5.22927 9.70847 -2.49168 4.71619 2.25155 -6321 6 39.5722 17.6819 9.57834 18.7012 -23.4437 -36.958 -6322 4 39.2207 17.6668 10.4653 -7.32211 -9.11094 11.7967 -6323 4 39.6226 16.7555 9.16114 -8.90732 35.1542 21.3272 -6324 6 31.4906 30.1663 28.5669 -18.2413 -3.40307 10.1233 -6325 4 32.2933 30.4252 28.099 2.93126 -8.695 5.25695 -6326 4 31.6493 29.3506 29.0723 8.50077 6.58979 -7.17605 -6327 6 52.667 19.2904 40.0609 -3.10376 4.72625 -3.48654 -6328 4 52.9542 18.5867 39.4362 -2.88314 13.2503 8.01058 -6329 4 53.0181 20.1618 39.7754 -0.243354 -8.89628 -7.05583 -6330 6 3.24103 7.80987 9.85575 15.4795 13.9798 -0.387217 -6331 4 3.75934 8.59525 10.1836 -13.0283 -21.6848 -11.3123 -6332 4 3.84189 7.30622 9.27659 -5.58147 6.91981 6.81825 -6333 6 23.1336 35.2172 35.587 -21.8844 -14.3383 30.559 -6334 4 23.8289 35.3646 34.9695 18.2116 12.6911 -23.5817 -6335 4 22.438 35.8962 35.5045 5.76256 0.966742 -5.52301 -6336 6 19.4997 14.0668 20.8253 -20.4482 -5.33672 -12.8711 -6337 4 19.9465 14.5101 21.5526 -0.10572 6.16799 9.82761 -6338 4 18.517 14.0876 20.9737 19.1914 1.01522 3.6393 -6339 6 23.6166 15.8675 24.0247 18.6101 -11.8924 -11.0295 -6340 4 23.7056 16.8159 24.0204 -5.88143 19.7526 4.0278 -6341 4 24.4592 15.5679 23.6279 -14.5441 0.474754 5.50536 -6342 6 0.271665 30.4941 6.10208 19.3679 10.4089 38.3983 -6343 4 55.0639 30.1609 5.24948 -13.9023 -9.5098 -30.2095 -6344 4 54.47 30.83 6.54681 -8.02886 -2.57547 -7.81581 -6345 6 4.88814 13.205 29.1223 -11.8587 -43.2127 -22.2411 -6346 4 4.78002 13.8458 29.7909 -3.08187 32.2273 31.1649 -6347 4 5.63816 13.4614 28.593 12.4558 6.3486 -8.85318 -6348 6 54.2078 27.2696 19.1963 -15.9712 -23.151 25.2067 -6349 4 0.0774591 27.3551 19.591 11.6552 0.895327 2.86932 -6350 4 54.2345 27.7605 18.3958 2.66703 17.7524 -27.3595 -6351 6 13.918 35.7451 9.18145 -1.78919 -38.7722 -17.1362 -6352 4 13.6805 34.9997 8.54227 8.11159 28.2534 18.027 -6353 4 13.9675 36.5302 8.63631 -0.993585 8.08981 -9.4946 -6354 6 5.91273 31.9181 18.8024 -12.4461 1.37758 17.74 -6355 4 5.51416 32.8097 18.9023 4.86685 -6.68339 -12.1033 -6356 4 6.30341 31.7597 17.9414 -1.0189 10.0948 -10.5031 -6357 6 5.79665 28.8753 9.48388 1.22923 1.68801 -9.18455 -6358 4 5.13151 29.3325 10.0083 -4.81051 1.68465 1.48607 -6359 4 5.29369 28.2634 8.9143 2.26517 5.17431 2.85494 -6360 6 40.1173 6.05944 9.72118 13.8961 -11.6659 -14.1698 -6361 4 40.0092 6.65032 8.94634 5.33155 -13.6 11.5113 -6362 4 40.8322 5.39707 9.49335 -23.1878 23.6737 0.508505 -6363 6 20.33 13.449 41.3936 11.1096 -0.534149 -19.18 -6364 4 21.2311 13.7006 41.7531 -26.0398 -5.61362 -19.048 -6365 4 20.2547 13.6822 40.4168 8.50391 -3.95591 26.8537 -6366 6 14.4455 21.736 27.3642 10.1345 -2.11962 18.0607 -6367 4 15.3888 21.7922 27.5976 -10.3958 0.0660495 -7.924 -6368 4 14.3649 21.6255 26.4124 4.42937 0.724974 -0.20238 -6369 6 38.7561 1.79551 30.0553 7.9914 -17.3849 -15.575 -6370 4 38.4573 2.01955 30.9195 -8.42419 6.13431 27.6354 -6371 4 38.9299 2.64677 29.6557 3.10695 8.29419 -8.65227 -6372 6 5.60526 10.8558 14.1801 -12.7318 -17.5226 5.68918 -6373 4 4.9397 11.5438 14.0518 -0.153792 0.369728 -2.18729 -6374 4 5.10481 10.0791 14.5379 11.5553 16.0131 -9.09073 -6375 6 45.3957 36.7129 27.9145 12.4213 23.5208 -28.0365 -6376 4 46.0624 36.7782 28.6036 -4.12954 -6.22049 8.27184 -6377 4 45.8092 37.2197 27.1638 -19.7894 -19.9635 17.4029 -6378 6 54.0798 35.0308 20.3994 -2.843 -1.86615 -11.5734 -6379 4 53.8804 34.0877 20.4832 1.52986 -2.36109 -0.337181 -6380 4 53.937 35.2424 19.4598 0.882668 -0.831705 10.9264 -6381 6 42.0694 14.2202 28.4717 21.1483 -3.98018 21.7174 -6382 4 41.9885 13.9669 29.4143 -10.3093 2.59547 -11.4583 -6383 4 43.02 14.3987 28.405 -3.82604 1.35242 -7.96462 -6384 6 34.8498 7.69636 26.7062 10.2576 -3.81921 3.94078 -6385 4 35.6291 7.30563 27.124 0.895866 5.46509 7.50645 -6386 4 34.5698 7.0105 26.0965 -7.64543 -1.95318 -6.87837 -6387 6 49.6738 30.7035 23.8555 -19.3272 -4.41511 -13.3992 -6388 4 50.4901 31.166 23.8286 28.3544 13.2291 -0.764283 -6389 4 49.8241 29.9642 24.4268 4.30872 -17.0733 16.2757 -6390 6 50.9008 7.796 14.1645 9.55664 -5.64416 8.78132 -6391 4 50.8079 7.01141 13.6383 2.57079 -23.1487 -4.84087 -6392 4 50.5017 8.45024 13.6177 -13.1237 27.0593 -11.2067 -6393 6 4.26801 39.4668 27.8349 5.05862 -9.29033 0.915363 -6394 4 3.69733 40.2352 27.9464 -2.13812 3.43039 0.251988 -6395 4 3.85787 38.9439 27.1453 -8.48589 -4.99062 -8.23097 -6396 6 8.74801 32.8245 8.20645 -16.3778 -23.5545 -4.64115 -6397 4 8.1587 32.1369 7.77132 15.1044 25.0089 5.08958 -6398 4 8.83862 33.6223 7.65804 -4.44885 -3.27239 -3.39484 -6399 6 52.9644 25.4956 9.38778 -23.0628 41.5097 8.07386 -6400 4 51.9653 25.4466 9.50894 36.2156 4.27363 -7.84863 -6401 4 53.1697 26.4737 9.50477 -8.20239 -39.1491 -3.41364 -6402 6 29.5595 36.7246 19.4744 18.9803 -2.04176 16.4704 -6403 4 29.6949 37.303 18.726 -4.20274 3.37351 -9.90607 -6404 4 30.4598 36.6303 19.854 -15.3589 -5.02994 0.251134 -6405 6 52.32 36.0811 25.1124 8.57954 -21.5781 -32.5589 -6406 4 53.081 35.9362 25.6725 3.50304 3.9365 6.54391 -6407 4 51.6308 36.4579 25.6293 -16.5409 10.2166 18.3955 -6408 6 21.1806 15.7021 31.1799 -1.73968 4.64344 -14.8668 -6409 4 20.7524 16.2958 30.5301 6.89899 -9.15256 14.6363 -6410 4 20.4997 15.2544 31.7027 -1.32541 3.0922 -5.22806 -6411 6 10.6615 22.4234 39.4446 2.77058 -10.3375 -21.7461 -6412 4 10.8237 22.5242 38.4595 -6.54577 -4.89624 27.0726 -6413 4 10.2823 21.5329 39.6036 8.10661 10.4602 -7.72978 -6414 6 25.1119 11.6683 22.7275 17.9584 10.1803 -43.002 -6415 4 25.2932 11.5881 23.6503 -10.3644 -4.73542 30.1579 -6416 4 24.2275 11.4525 22.4127 -3.04384 -6.16919 15.0614 -6417 6 31.7847 10.4664 2.90738 14.6232 4.92747 -25.5509 -6418 4 32.6367 10.8084 3.16838 3.35352 3.27745 17.8769 -6419 4 31.9203 10.4929 1.94425 -15.217 -5.45404 8.94289 -6420 6 52.4827 36.4345 22.1596 -7.80713 -36.8893 3.58418 -6421 4 53.0619 36.0081 21.4904 -7.85296 7.00584 7.09748 -6422 4 52.1113 35.6558 22.6625 11.8438 27.843 -13.8236 -6423 6 46.2218 40.0356 27.0002 3.00948 19.3103 18.0239 -6424 4 46.4695 39.2891 26.4839 7.60887 -23.2108 -12.3358 -6425 4 45.8298 40.6551 26.3816 -4.98516 2.75312 2.41297 -6426 6 24.0859 36.731 39.1057 28.0861 3.14637 -13.7231 -6427 4 23.7868 35.8298 38.9338 -5.18553 -0.74556 5.28182 -6428 4 23.4629 37.185 39.6652 -17.6872 -1.49015 10.8999 -6429 6 22.3474 7.42423 31.8108 -22.1464 -34.764 6.81692 -6430 4 22.3426 8.34479 32.0749 -0.491553 12.3501 5.32307 -6431 4 21.6443 6.94951 32.3421 24.5486 22.6275 -17.4273 -6432 6 14.3601 18.3609 4.10227 -5.91068 -17.6869 34.0105 -6433 4 14.0198 17.4467 4.00899 4.58845 16.3972 -3.13031 -6434 4 14.1964 18.4938 5.07185 10.0688 2.42213 -23.7444 -6435 6 27.3176 38.4584 0.118061 26.6324 1.72941 22.4386 -6436 4 26.8721 39.2229 0.514978 -6.24738 0.955789 -1.68833 -6437 4 28.1825 38.4197 0.615747 -27.5588 -2.17115 -12.0629 -6438 6 18.6641 0.153005 12.2455 -30.1585 11.9093 7.70812 -6439 4 17.6838 0.288413 12.4195 29.795 -10.6896 -3.23208 -6440 4 18.9224 41.3021 12.7767 -6.14336 -8.14908 8.56265 -6441 6 49.4289 24.9791 25.34 -2.93287 6.40986 -7.21031 -6442 4 48.5336 24.6845 25.5066 -4.79022 -10.2209 3.00881 -6443 4 49.2657 25.7332 24.7569 10.0796 0.538989 -0.302405 -6444 6 52.0657 20.2866 15.752 -30.988 -5.77477 12.2451 -6445 4 52.9883 20.4648 15.7877 30.7647 6.19501 2.10932 -6446 4 51.7487 20.318 16.6754 2.59628 0.707672 -8.61894 -6447 6 49.6694 15.6466 38.5033 -2.36871 5.8496 0.21755 -6448 4 49.1634 15.9354 37.7317 2.81773 -6.75889 -8.88584 -6449 4 49.3364 16.2327 39.1899 -1.1635 1.82265 11.9188 -6450 6 15.9209 23.7098 13.4125 14.0576 3.0382 28.6395 -6451 4 16.4576 23.7581 14.2247 -6.14337 -14.5589 -15.9509 -6452 4 15.4928 24.5639 13.4473 -12.8057 7.70559 -12.0572 -6453 6 14.3535 29.1644 14.3158 -5.44214 8.41065 -10.6214 -6454 4 14.1107 29.5404 13.4323 4.3831 -8.60004 22.5031 -6455 4 14.1668 29.874 14.9595 1.02369 -3.68708 -8.8215 -6456 6 30.4209 19.8501 16.8941 13.513 -29.8099 -4.40702 -6457 4 30.8419 19.6061 17.7309 -1.16118 4.00396 0.0836579 -6458 4 29.8867 20.6126 17.0073 -13.0379 22.0094 6.56408 -6459 6 21.3171 21.0315 23.1347 13.77 4.04154 19.3244 -6460 4 22.2214 21.2364 23.4619 -15.8088 -1.32345 -6.31481 -6461 4 20.7299 21.1568 23.8987 5.07857 1.54253 -3.54042 -6462 6 32.3393 0.431439 25.2563 20.1104 -9.0179 2.05206 -6463 4 32.3376 0.357033 24.2893 -5.83171 4.85221 4.50445 -6464 4 31.4939 0.740536 25.5658 -20.5297 5.12544 -3.04931 -6465 6 26.1412 32.4208 27.5133 11.9844 8.82666 12.5058 -6466 4 25.6297 33.2181 27.3271 -3.7928 0.326337 -6.17907 -6467 4 25.9506 31.7475 26.8638 -6.12498 -3.36782 -14.5181 -6468 6 31.6886 23.0183 41.4596 0.904697 7.64904 11.3452 -6469 4 32.5758 22.6752 41.6838 -11.075 0.532718 -2.08438 -6470 4 31.0649 22.7115 0.227606 5.71652 1.16966 -4.3825 -6471 6 54.3662 17.838 10.7289 1.16641 13.6113 28.4031 -6472 4 53.5784 18.2682 10.4091 -15.835 11.3767 1.3744 -6473 4 54.5574 17.2244 10.05 12.0924 -25.2322 -22.7117 -6474 6 15.4007 28.5656 8.62044 -26.1749 5.76845 -41.3303 -6475 4 14.7273 28.9702 8.01425 13.7656 -2.21873 23.1298 -6476 4 15.8479 27.9621 8.001 5.22436 1.48231 12.0756 -6477 6 21.9302 22.318 27.6758 1.68517 -22.7815 -10.3197 -6478 4 22.2029 23.2377 27.6948 5.32233 7.77922 8.4028 -6479 4 21.9507 21.9579 28.5708 1.77406 4.33165 6.10734 -6480 6 2.9439 17.0434 8.14058 1.94164 -24.3442 -12.3304 -6481 4 3.71771 17.0381 7.53295 -10.9103 8.58946 10.7103 -6482 4 2.9095 17.8301 8.67828 12.1388 15.179 1.9509 -6483 6 27.5776 18.2769 3.9771 26.0492 -34.2565 5.18616 -6484 4 26.8914 18.9079 3.85686 -19.1066 25.6869 -8.0303 -6485 4 28.3968 18.6065 3.57961 -12.2542 3.89161 2.52414 -6486 6 24.7648 24.5394 8.45172 0.675902 5.99664 -6.73781 -6487 4 25.0691 23.6382 8.29185 0.995795 -2.08458 0.0885467 -6488 4 24.6379 24.6158 9.40394 1.7631 1.80546 -0.516948 -6489 6 41.9985 30.4652 13.7873 -12.418 22.2399 8.0521 -6490 4 42.948 30.5766 13.6065 -4.54142 -18.1038 -0.632901 -6491 4 41.6543 29.5567 13.7855 17.2179 -0.450275 -1.52495 -6492 6 15.7003 34.688 41.5836 22.5583 -4.71252 2.77114 -6493 4 16.4414 35.3131 41.7067 -7.89455 1.74939 1.29748 -6494 4 14.9091 35.1782 41.7999 -10.5684 8.94915 5.66738 -6495 6 11.14 19.7709 40.5827 8.16812 -24.8495 -13.7269 -6496 4 12.099 19.6958 40.4335 -6.97557 5.6239 6.72769 -6497 4 10.8269 18.8658 40.3418 -4.09458 16.1616 8.77151 -6498 6 47.4994 34.5266 14.3059 -7.29954 -13.2064 -47.3862 -6499 4 46.9486 35.2618 14.0194 -1.26876 14.2822 14.9014 -6500 4 47.5134 34.0178 13.447 14.161 -1.19014 30.6955 -6501 6 12.4113 26.9599 28.4986 7.53387 -39.615 -11.3807 -6502 4 13.2389 26.8759 29.0383 -9.69033 -7.26437 -10.917 -6503 4 12.3547 26.143 27.8911 8.77392 33.3418 27.7102 -6504 6 27.6324 16.2078 39.8226 -15.7166 38.3334 10.2244 -6505 4 27.1738 15.4871 40.2515 -0.529449 -16.0233 0.418904 -6506 4 28.2783 15.8881 39.2072 13.4358 -18.0852 -11.4488 -6507 6 33.41 31.2223 27.2648 1.06056 32.1352 -34.8736 -6508 4 34.1408 31.8147 27.4795 4.37007 -7.45055 8.12396 -6509 4 32.9956 31.7298 26.5244 2.74339 -19.701 12.9858 -6510 6 39.1079 39.5697 31.9277 -2.55925 2.09297 0.92959 -6511 4 38.7672 39.6549 31.0188 2.43701 -1.71218 7.87361 -6512 4 38.6143 40.212 32.4659 5.60044 -5.69156 -1.85126 -6513 6 22.8777 16.5449 19.9566 -5.65986 -8.80894 -1.36967 -6514 4 23.3352 15.8067 20.4264 -14.7096 4.17994 -10.0586 -6515 4 22.0919 16.2116 19.4632 15.4216 -6.99735 9.66589 -6516 6 23.9693 21.8661 10.5894 -36.2244 3.36606 3.40233 -6517 4 22.9782 21.9097 10.6297 20.8239 3.29656 -5.85881 -6518 4 24.1356 21.2379 11.286 10.3432 -8.66819 12.8402 -6519 6 40.1777 25.441 2.79106 -10.2872 18.2283 6.37262 -6520 4 40.1705 25.0132 3.63888 8.49445 -17.5146 10.0011 -6521 4 39.7592 26.2809 3.01477 -1.02299 2.45309 -8.63041 -6522 6 15.0237 19.7749 9.41859 -29.0071 17.4399 5.80075 -6523 4 14.7228 20.7104 9.1599 7.38 -34.1593 9.70733 -6524 4 14.2459 19.2857 9.84339 25.5779 21.3804 -17.4983 -6525 6 7.16152 24.8628 0.123297 -7.02966 -3.56682 11.7049 -6526 4 7.96668 24.8036 41.5398 15.214 -7.46464 -23.6733 -6527 4 7.46323 25.2953 0.914133 -6.27594 4.44234 13.0485 -6528 6 43.3927 10.9201 31.3407 25.4071 10.106 7.84859 -6529 4 43.8098 10.8609 30.45 -7.40798 -0.791197 19.4909 -6530 4 44.1598 10.9733 31.9767 -21.009 -0.343387 -21.8186 -6531 6 13.8353 19.068 27.8558 -6.19586 12.3763 0.85665 -6532 4 12.975 18.7858 28.1864 -1.64107 2.23065 2.52451 -6533 4 13.8413 20.053 27.8412 2.88957 -13.8419 -2.19198 -6534 6 3.4728 19.5924 9.6022 -44.5705 9.69836 1.75794 -6535 4 2.70361 20.0095 10.0844 20.5969 -13.9146 -9.89239 -6536 4 4.25765 19.8234 10.0844 13.5534 0.0599395 5.99295 -6537 6 51.0213 19.4268 7.70955 2.43945 12.0622 -23.2725 -6538 4 50.6325 20.2627 7.28999 21.6228 -31.5555 10.1722 -6539 4 51.8004 19.115 7.16203 -27.7652 18.9123 7.69536 -6540 6 42.2139 2.59999 10.4154 11.3377 -7.01405 -0.847173 -6541 4 43.144 2.57533 10.7556 -19.516 1.89174 -10.2127 -6542 4 42.1979 2.39197 9.45142 9.27815 6.14572 20.7298 -6543 6 30.7794 6.42968 35.1975 -13.4378 -7.3385 -2.08895 -6544 4 29.8146 6.43175 35.3648 9.73054 -4.02703 -1.93701 -6545 4 31.052 5.50707 35.0427 -6.67101 6.52405 0.860042 -6546 6 52.8733 36.9495 18.5906 -4.95733 10.1612 -6.16245 -6547 4 51.9909 36.5548 18.5738 -2.549 -5.51132 1.40056 -6548 4 52.7192 37.8514 18.247 7.64894 -10.0112 4.74408 -6549 6 44.2058 6.2999 1.04709 5.21291 8.10008 11.2107 -6550 4 44.5368 6.97198 1.69742 -2.24215 -10.2401 -12.34 -6551 4 44.9393 6.09517 0.464894 1.54959 1.89788 1.1267 -6552 6 42.1369 38.61 31.1886 17.67 -9.24899 26.4806 -6553 4 41.7623 38.8803 30.3687 -14.3725 6.55505 -24.001 -6554 4 41.498 38.8614 31.8609 -3.32676 4.75778 -0.202389 -6555 6 43.7164 12.7972 9.05712 5.81528 3.72875 -30.711 -6556 4 43.3247 13.6946 8.89573 9.87346 -21.9812 3.16194 -6557 4 44.14 12.4709 8.19462 -12.6006 16.8915 32.7492 -6558 6 13.3844 0.443398 6.51083 -17.4423 24 5.83044 -6559 4 13.1471 1.18968 7.12521 11.9969 -17.0568 -16.1514 -6560 4 13.404 0.824606 5.60344 -0.330864 -2.32474 10.3957 -6561 6 16.1322 13.2809 10.2756 -7.67495 0.483234 -7.74316 -6562 4 16.9315 12.7781 10.4995 -2.28882 -8.98658 -2.43525 -6563 4 15.4389 12.669 9.92885 16.2568 3.72445 6.60733 -6564 6 1.59909 8.47465 4.69565 -12.106 -24.0688 17.9122 -6565 4 1.97809 9.06493 4.05503 13.7499 12.9224 -12.6029 -6566 4 2.17818 8.51684 5.47441 1.43398 4.73372 -5.14276 -6567 6 37.2847 1.71984 10.5234 11.0189 -27.5723 -13.4042 -6568 4 37.2468 2.67416 10.4778 -4.00861 9.27523 10.0347 -6569 4 36.8996 1.35439 11.335 -2.27729 16.2243 3.90618 -6570 6 53.8329 9.87891 17.6846 -38.3798 -30.924 7.14602 -6571 4 54.5301 10.0186 17.0634 18.0368 1.02749 -18.7159 -6572 4 53.3473 9.06138 17.3773 12.8854 20.2391 7.24153 -6573 6 45.4804 30.6107 15.8042 -8.04753 0.598448 7.23065 -6574 4 44.8245 31.2304 16.205 12.7241 -16.0174 -7.51778 -6575 4 45.2045 29.6903 15.9459 -0.384376 11.4708 0.631615 -6576 6 39.9212 16.643 33.8508 -27.7636 -7.17353 -19.4615 -6577 4 39.1766 17.1755 33.458 21.1378 -12.4278 10.7513 -6578 4 39.8244 15.7487 33.4296 5.23768 21.8708 14.061 -6579 6 32.8655 24.7639 27.9361 20.284 59.6053 -7.49862 -6580 4 33.6165 25.1458 28.4374 -8.60268 -19.6727 -0.650124 -6581 4 32.6313 25.5876 27.4183 -1.69816 -34.155 10.7383 -6582 6 7.87466 31.6143 24.1101 1.9117 20.6925 26.3443 -6583 4 7.66972 30.8573 24.7192 5.27436 26.873 -8.7819 -6584 4 7.9908 32.4716 24.6533 -12.57 -44.6195 -20.0842 -6585 6 43.5378 41.3358 15.8218 9.28004 -2.58796 -1.50951 -6586 4 43.1443 0.2957 15.6997 -2.19094 2.48586 -2.7957 -6587 4 44.4004 41.3722 15.3768 -7.99823 -0.449815 2.36698 -6588 6 20.0371 29.5453 33.205 3.08504 -20.5033 -11.6211 -6589 4 20.9096 29.2965 33.5637 -2.90058 10.2459 9.35691 -6590 4 19.6251 30.2513 33.706 8.84517 7.80605 8.87396 -6591 6 43.4117 21.4438 18.6347 -11.1342 -15.0059 14.8538 -6592 4 43.0276 21.2687 19.5098 8.56326 4.46648 -0.801958 -6593 4 42.8532 20.9111 18.0542 1.01153 2.95656 -9.2223 -6594 6 3.44653 19.1197 18.4217 23.6769 1.99723 9.81042 -6595 4 3.20802 20.045 18.3207 -2.32682 2.96104 -2.33529 -6596 4 2.63398 18.6303 18.3598 -12.7596 -8.76931 -2.32568 -6597 6 41.6678 38.1102 16.3244 12.531 -42.2252 -39.0953 -6598 4 41.9368 37.3879 15.641 -15.3799 38.9729 30.6603 -6599 4 42.3331 38.0554 17.0146 -0.0757724 1.18921 2.99625 -6600 6 7.55561 36.3978 10.4983 -3.44092 15.1931 -1.45671 -6601 4 6.72339 36.2337 10.0108 12.3142 -8.52859 4.51616 -6602 4 7.946 35.5335 10.7116 -10.6452 2.04557 -4.50299 -6603 6 36.2515 19.1074 34.8142 -43.7142 -17.0801 -27.3746 -6604 4 35.3817 19.3303 34.3863 23.1726 -6.06315 12.306 -6605 4 36.4633 19.8781 35.3097 10.3 22.3537 14.1292 -6606 6 53.5678 24.9372 12.6442 30.4342 18.5181 -32.2976 -6607 4 53.8348 25.8921 12.6266 -11.9077 -21.6197 10.5864 -6608 4 54.0165 24.5977 11.8224 -16.4724 -4.37861 26.9125 -6609 6 31.6766 10.443 21.0806 4.21881 -9.06253 -2.47208 -6610 4 31.4001 9.76622 21.7243 -7.70504 9.2495 -8.08332 -6611 4 30.9288 10.6617 20.4921 1.78432 -8.02731 8.28605 -6612 6 18.1094 28.7798 17.1891 14.7524 22.0605 -19.6834 -6613 4 19.0758 28.769 16.9872 -20.2742 -2.10771 9.28657 -6614 4 17.7731 29.5847 16.7123 5.43167 -23.0331 15.3038 -6615 6 21.675 18.2354 36.8765 16.12 -15.5286 8.52342 -6616 4 22.5529 17.9072 36.565 -22.4082 10.693 4.11156 -6617 4 21.5572 17.762 37.7329 -6.04816 8.67317 -10.9669 -6618 6 25.0658 19.0188 34.2159 -51.8076 2.97265 19.7815 -6619 4 24.747 18.4039 34.9114 5.38902 10.2451 -10.362 -6620 4 25.8774 18.6629 33.96 52.7001 -22.9877 -15.275 -6621 6 15.5692 13.0234 5.56242 -6.58245 2.44228 -13.4315 -6622 4 15.9945 13.4237 6.33643 -0.981395 -11.5063 2.18089 -6623 4 15.4281 12.0558 5.58603 5.20341 13.6823 8.40676 -6624 6 54.4716 41.6235 14.8012 14.2089 2.8312 2.80672 -6625 4 54.7869 41.5367 15.7234 -10.706 -4.16636 -8.71187 -6626 4 53.6678 41.1066 14.6963 -6.31993 -3.99892 7.53898 -6627 6 1.6781 26.4654 31.3743 5.67012 -21.4195 51.4057 -6628 4 2.55869 26.331 31.7713 -6.41431 -1.4007 -7.54986 -6629 4 1.81482 26.7235 30.4972 11.6805 15.9936 -52.9786 -6630 6 32.3382 37.285 29.6856 -26.7217 17.5069 7.43983 -6631 4 31.5807 37.8924 29.918 20.5429 -15.6126 -5.39856 -6632 4 33.128 37.6701 30.0913 2.74033 -1.11204 0.131524 -6633 6 52.7155 21.0369 22.8986 -26.6856 13.1044 -7.83906 -6634 4 51.927 21.5218 22.5308 17.9584 -10.8856 16.9396 -6635 4 53.1096 20.6236 22.131 10.0871 -9.76004 -3.40095 -6636 6 32.7546 28.5936 40.5151 -16.005 5.57574 20.6704 -6637 4 31.9696 29.0914 40.2712 1.08408 5.35728 -15.103 -6638 4 32.4826 28.2925 41.3957 13.2257 -7.23298 -6.66392 -6639 6 23.6064 32.0719 16.3529 6.2601 0.887785 0.577407 -6640 4 24.375 31.9361 16.9584 -22.6405 4.1158 -3.2487 -6641 4 22.7879 32.3052 16.8361 12.3926 -5.56708 -0.502672 -6642 6 37.5201 9.16809 29.9792 -2.73778 -7.47015 7.66604 -6643 4 36.7801 8.78215 30.4957 3.311 11.363 -11.2805 -6644 4 37.2059 9.98527 29.541 -5.1069 -9.85197 8.55889 -6645 6 2.27705 24.391 14.5477 -18.8311 -23.8216 -15.5117 -6646 4 1.75426 24.0938 15.3142 10.0576 11.8704 2.19803 -6647 4 1.95568 23.7778 13.8474 11.5886 17.7779 11.9828 -6648 6 27.3753 28.7961 24.7726 7.21008 -25.2057 -20.8265 -6649 4 27.1644 28.4274 25.6317 -2.92196 -0.0765173 10.3399 -6650 4 27.4291 28.0161 24.1505 1.02404 24.316 14.9 -6651 6 16.7879 2.56531 14.3086 11.9129 14.2285 -1.69346 -6652 4 17.7185 2.38196 14.3175 13.0278 5.32386 8.84309 -6653 4 16.4775 1.81817 13.8231 -22.7045 -15.6449 -12.1127 -6654 6 21.8022 39.8027 36.8001 40.4582 11.674 1.33338 -6655 4 22.755 39.5599 36.9347 -17 12.4394 -0.288792 -6656 4 21.461 38.9709 36.5396 -21.7153 -28.8447 -11.0269 -6657 6 14.0716 6.47232 41.542 21.0202 -14.2424 -6.97231 -6658 4 14.9696 6.10406 41.5939 -1.81915 -4.72532 -7.76656 -6659 4 14.0403 6.99701 0.421866 -13.8031 9.98176 13.4178 -6660 6 14.5555 16.5106 9.31543 20.3876 4.44524 4.12907 -6661 4 15.4025 16.5964 9.78828 0.864554 -6.42184 -12.9633 -6662 4 13.9847 17.046 9.86181 -12.8914 3.93145 3.80898 -6663 6 8.66171 23.4817 30.5575 -0.244333 -0.896371 32.8135 -6664 4 9.54353 23.6001 30.2398 18.7576 4.73722 -27.2602 -6665 4 8.85707 23.3999 31.5064 -16.6456 -3.41855 -0.290363 -6666 6 37.6497 2.07069 20.0046 29.2824 -26.1096 14.9164 -6667 4 37.0584 2.2163 19.2662 -13.6051 13.4744 -1.64318 -6668 4 37.4656 2.68422 20.7276 -9.488 6.31449 -9.7769 -6669 6 42.7264 7.54802 8.0174 22.2735 -23.3375 63.966 -6670 4 43.1898 7.96838 7.30926 14.9789 10.8108 -11.9713 -6671 4 43.3711 7.43923 8.8454 -34.4126 10.1207 -51.4479 -6672 6 38.5672 29.6578 6.85692 25.3422 5.29964 1.58487 -6673 4 38.5311 29.2984 7.75245 -9.71234 0.328663 -2.10015 -6674 4 37.7248 29.5682 6.41889 -15.2832 -4.18317 0.54199 -6675 6 42.5348 15.7114 39.7967 1.15785 13.3588 -25.5786 -6676 4 42.7129 16.6429 39.5831 1.88136 -1.51067 11.9166 -6677 4 42.2359 15.3735 38.9271 3.70013 -4.77916 17.2749 -6678 6 19.8546 7.43685 22.0566 -22.5975 2.81071 25.7956 -6679 4 19.2803 8.13273 21.6746 8.521 -7.13733 1.21439 -6680 4 19.4015 7.21173 22.9242 12.7412 8.86068 -31.9054 -6681 6 27.421 3.23371 12.5304 27.0524 21.0752 -24.489 -6682 4 28.3367 3.35644 12.1327 -27.9555 -7.8832 14.1518 -6683 4 27.3543 2.31638 12.8154 4.42645 -1.52034 -0.990676 -6684 6 34.4011 6.50186 34.3664 -16.3424 -2.90191 9.94761 -6685 4 33.6712 7.15225 34.4215 6.78416 -7.62851 1.00734 -6686 4 34.1394 5.7575 34.9538 2.66911 12.7001 -5.69623 -6687 6 9.88701 27.9536 39.7574 38.1218 -1.21446 9.36845 -6688 4 10.8313 27.9815 40.1009 -35.4969 -5.93471 -11.3457 -6689 4 9.7403 28.8357 39.397 -3.9481 4.17466 -3.11552 -6690 6 50.5681 22.1235 6.40489 -3.33101 1.51672 6.50125 -6691 4 51.5163 22.3536 6.46403 -14.0562 3.33212 10.0382 -6692 4 50.0608 22.5915 7.10741 15.6039 -2.37345 -9.267 -6693 6 47.1098 11.477 30.0359 32.4056 2.61276 18.961 -6694 4 47.3696 10.9259 30.8115 -10.3246 7.95021 -16.9085 -6695 4 46.3045 11.1726 29.6407 -20.48 -14.5539 -1.24473 -6696 6 25.9367 28.4654 9.80931 -8.38409 -27.2904 31.5361 -6697 4 26.8395 28.2564 10.1264 -14.1867 1.81997 -4.27567 -6698 4 25.3175 27.9176 10.3882 19.4096 21.4407 -17.1039 -6699 6 35.4417 36.6052 19.4431 3.65383 9.51374 12.5698 -6700 4 35.4442 36.5892 20.4356 4.35023 4.13201 -20.4161 -6701 4 36.0823 37.2978 19.1702 -7.18083 -5.57131 7.61291 -6702 6 39.0947 17.861 12.3005 -1.37104 18.7141 6.38745 -6703 4 39.0516 18.8013 12.5757 6.4741 -5.57949 -8.41576 -6704 4 38.3925 17.481 12.8252 -9.64523 -10.3587 5.73293 -6705 6 2.67895 27.1328 2.39169 -0.469231 -1.96621 -7.87892 -6706 4 2.01695 27.5866 1.84113 6.06579 -3.44887 4.00529 -6707 4 2.54603 27.3828 3.31988 1.36543 -1.57126 -4.01383 -6708 6 12.3125 32.2183 21.5204 7.73608 31.3279 -34.5621 -6709 4 12.8754 32.1648 22.302 -15.5368 -9.13091 6.69049 -6710 4 11.4514 31.7997 21.5885 -0.151568 -8.94455 23.3893 -6711 6 32.8824 32.3641 8.46179 -18.8611 4.30442 3.1153 -6712 4 33.4241 32.9657 8.96292 17.2175 7.79223 5.74753 -6713 4 32.0088 32.7748 8.50666 0.635289 -6.40729 -7.5616 -6714 6 12.649 6.44414 31.9754 -2.83404 4.50046 10.0363 -6715 4 13.204 6.32185 31.2101 8.19857 -2.9014 -11.0209 -6716 4 11.7563 6.235 31.704 -2.09981 -3.08597 -3.85403 -6717 6 41.3663 27.7408 14.044 -7.1512 -14.0341 -18.9391 -6718 4 41.8178 27.3798 13.2339 -12.2472 13.3456 19.5442 -6719 4 40.4043 27.5413 13.9741 19.5004 0.843126 1.31278 -6720 6 6.61204 16.505 25.4358 4.38086 10.1107 -4.22872 -6721 4 7.40634 15.95 25.3995 -3.52048 -0.326181 -5.74655 -6722 4 5.93615 16.0015 24.9584 5.4209 -2.01242 3.85811 -6723 6 21.7595 39.2992 13.3504 -47.5104 6.20728 42.9111 -6724 4 22.3466 39.2605 12.6295 26.4998 6.28224 -34.1528 -6725 4 21.7095 40.2078 13.7281 10.6984 -16.5323 -14.9329 -6726 6 34.8487 6.01484 6.95222 -29.6963 0.326386 -14.1862 -6727 4 33.862 5.88861 6.88689 25.1099 2.0969 11.0318 -6728 4 35.0754 6.24807 6.0365 6.49139 -1.48305 5.74594 -6729 6 33.0274 30.4243 33.1708 -20.2868 -13.6057 -33.0226 -6730 4 32.107 30.5622 32.8069 24.6222 -1.48625 15.7647 -6731 4 33.1252 31.0225 33.8918 -2.19017 18.1524 16.6028 -6732 6 15.459 32.4153 12.1907 25.026 -14.7999 12.6103 -6733 4 16.3707 32.0454 12.2858 -22.5133 7.43237 -2.39957 -6734 4 15.4871 32.8857 11.3664 4.63911 10.1509 -16.175 -6735 6 12.6896 26.6018 21.3639 -15.0944 -25.6853 -2.70918 -6736 4 11.948 26.0906 21.6799 0.937138 -29.673 -19.3981 -6737 4 12.542 27.2759 21.9777 19.0907 58.813 21.5342 -6738 6 47.0229 36.3064 29.9951 -7.32095 -4.41829 24.4392 -6739 4 47.4263 37.0889 30.4354 -10.9743 -13.05 -1.23566 -6740 4 46.4286 35.8162 30.6445 23.161 23.2616 -16.2608 -6741 6 0.29284 12.714 23.4069 -35.5625 7.7859 6.41586 -6742 4 0.591011 11.8915 23 -3.04289 0.952694 -0.179009 -6743 4 54.2726 12.6526 23.4069 36.7156 0.482893 -0.227565 -6744 6 54.1717 18.9252 21.5683 -50.0663 20.0699 0.290361 -6745 4 -0.00468748 18.6783 21.9698 30.2345 -16.5238 -1.58257 -6746 4 54.0846 18.73 20.626 15.626 -5.42297 0.74208 -6747 6 25.7258 24.2992 23.7444 19.803 -45.4072 -0.235584 -6748 4 25.1532 23.5493 23.4006 14.0979 28.9064 13.4272 -6749 4 26.557 23.8171 24.0636 -29.432 23.3848 -10.2309 -6750 6 11.8983 29.0288 26.8736 6.09277 -0.515715 3.71925 -6751 4 12.595 29.6797 27.0784 -3.35093 -5.68029 1.25498 -6752 4 11.9864 28.3255 27.5444 1.01315 10.8055 -7.75858 -6753 6 47.9911 35.8567 10.6981 8.08413 -4.02984 -21.6227 -6754 4 48.7745 35.7734 10.1229 -13.6418 -1.85084 -2.1863 -6755 4 48.3792 36.2903 11.4463 -1.30569 7.34959 21.4512 -6756 6 47.672 29.8438 36.9511 38.562 -32.0587 -16.7646 -6757 4 48.1514 29.311 36.2244 -26.8687 25.3781 26.6073 -6758 4 46.9232 30.3209 36.5927 -0.690739 -0.634879 -8.58348 -6759 6 7.33835 12.3416 10.615 -8.89583 -3.33234 -10.1121 -6760 4 7.22469 12.7824 9.73793 -1.24183 -8.23722 19.221 -6761 4 6.50851 12.5236 11.1156 17.4449 -0.896679 -14.5349 -6762 6 52.929 15.961 4.90278 -10.2898 -1.28264 -8.50781 -6763 4 53.0348 16.1145 3.95774 -1.18717 -0.815743 4.35872 -6764 4 53.806 16.0238 5.26597 15.814 -0.370642 9.21047 -6765 6 10.6777 16.9586 34.6035 -55.1347 -38.7426 5.67968 -6766 4 10.8984 16.7766 35.5088 23.7364 14.024 15.8473 -6767 4 9.8802 16.3472 34.5582 30.0556 27.9196 -18.3163 -6768 6 25.1377 31.056 36.0048 1.42921 -10.848 -28.6765 -6769 4 25.7744 31.7772 36.0714 -0.417948 1.95283 3.18329 -6770 4 25.3475 30.6244 35.1463 -8.66047 8.51414 18.9355 -6771 6 34.0941 21.8921 41.4705 -2.59948 8.49748 21.8065 -6772 4 33.8376 21.0023 41.2487 -0.891159 -17.6747 -3.00217 -6773 4 34.5263 22.2081 40.6953 10.3371 11.5397 -24.1167 -6774 6 15.7674 30.0637 1.25444 19.4532 4.17941 -23.0135 -6775 4 15.204 30.4318 1.91689 -16.4157 4.77211 21.8875 -6776 4 16.1981 30.8773 0.915598 -5.77798 -19.2538 1.08217 -6777 6 29.5177 27.8662 16.6069 -21.9867 -20.8772 26.8051 -6778 4 29.4575 26.8938 16.8925 2.72258 42.9501 -5.19299 -6779 4 28.8337 28.3532 17.1557 16.905 -14.8206 -13.8895 -6780 6 39.6418 9.77683 0.55649 6.97543 15.8838 23.3716 -6781 4 40.1108 10.6055 0.868863 -11.4024 -23.0197 -7.66085 -6782 4 39.4946 9.23542 1.36828 3.21978 8.9832 -14.2415 -6783 6 1.52158 31.8692 16.4183 -13.8984 7.04184 27.8471 -6784 4 2.05742 32.2974 15.7673 16.5414 8.9668 -16.2997 -6785 4 1.54493 30.9444 16.2035 3.31157 -20.7597 -8.56027 -6786 6 8.73651 39.8559 25.0424 -4.76165 -15.5453 0.0774869 -6787 4 8.05377 39.648 25.6948 0.177415 -5.7342 -2.33302 -6788 4 8.86744 40.7877 25.1714 9.39418 20.2019 -3.50565 -6789 6 42.3206 10.2864 9.76098 2.95973 19.1246 -1.63703 -6790 4 42.201 10.133 10.7061 4.21692 -0.996774 -0.328573 -6791 4 42.7677 11.1578 9.6855 -5.09192 -13.1904 -0.0451331 -6792 6 13.2407 7.61713 1.96996 -7.39862 -1.41628 8.88927 -6793 4 13.9913 7.91748 2.51852 -7.45732 -2.50241 0.703823 -6794 4 12.5579 7.21318 2.54911 15.3337 9.06064 -6.21655 -6795 6 18.7418 40.0591 14.2229 14.6643 6.60726 6.61579 -6796 4 19.3344 39.8885 14.9901 -13.3575 3.17545 -12.3588 -6797 4 17.9636 39.4956 14.2872 3.6042 -5.87931 7.54738 -6798 6 20.1073 14.0529 38.5598 27.8117 -61.2518 1.76132 -6799 4 20.1641 13.6472 37.6602 -4.05869 13.902 17.7453 -6800 4 19.784 14.907 38.4293 -21.3136 56.4597 -12.4562 -6801 6 22.6529 28.8869 34.0687 6.58134 -12.6264 20.4136 -6802 4 23.051 28.2341 33.486 -0.980474 2.102 -8.59088 -6803 4 22.967 28.5961 34.9503 -6.50134 7.38476 -6.63172 -6804 6 22.6736 4.71248 5.24178 -0.00794307 -2.96021 -16.86 -6805 4 22.1728 3.90748 5.48978 2.26378 16.1145 9.27739 -6806 4 22.7088 5.35566 5.95806 -4.05577 -5.29394 11.9552 -6807 6 23.6374 34.0001 38.3917 50.061 26.1352 -20.3518 -6808 4 22.8137 33.6238 38.6177 -41.7704 -11.5062 -0.965889 -6809 4 23.6153 34.3835 37.4812 -9.56218 -11.3792 16.4738 -6810 6 48.3816 21.3644 17.2759 -0.964958 21.4078 15.1884 -6811 4 48.1603 22.346 17.2347 5.31328 -30.3781 -7.15015 -6812 4 48.2799 20.9337 16.4123 -2.86285 15.3202 1.32987 -6813 6 11.5786 11.0066 8.63803 -22.8025 30.9503 41.2381 -6814 4 11.6342 10.2487 9.24135 6.24209 -4.12245 -6.65597 -6815 4 11.0653 11.6976 9.17674 20.0011 -23.9124 -25.5895 -6816 6 40.098 28.1667 33.502 25.4322 5.13826 0.328547 -6817 4 41.0532 28.3457 33.4282 -8.43417 -7.39989 8.78785 -6818 4 39.8078 28.5143 32.6608 -12.8477 1.2165 -2.93222 -6819 6 47.3852 25.6796 5.28879 12.5804 32.9376 -10.0311 -6820 4 46.4546 25.5561 5.13624 -16.8804 -10.2001 -0.268496 -6821 4 47.5232 26.6241 5.03253 2.87445 -14.5067 3.75712 -6822 6 21.6604 35.221 23.9985 9.0652 15.9564 -12.6156 -6823 4 21.5339 34.4977 24.6161 5.50034 -7.33202 6.93593 -6824 4 22.5891 35.5406 24.0132 -10.9025 -9.97729 6.37443 -6825 6 8.25067 41.5023 8.40693 4.57396 0.593767 -7.67714 -6826 4 8.14583 40.8128 7.73311 1.23406 2.32353 -0.157563 -6827 4 7.86929 41.1416 9.20784 -2.18245 3.41182 6.12515 -6828 6 16.4756 31.0916 22.2208 -15.8048 -5.76047 -3.57767 -6829 4 16.9823 30.8797 21.4186 0.224111 -1.11381 3.57708 -6830 4 17.0871 31.1495 22.9566 10.3822 -1.94934 1.40451 -6831 6 54.7052 0.441622 28.3216 30.4392 7.42547 7.16367 -6832 4 0.670225 0.280878 28.2941 -2.60978 -25.0778 -11.1355 -6833 4 54.7831 1.35385 28.5964 -22.0828 12.0381 3.63841 -6834 6 48.4365 15.3814 4.18175 16.1137 -59.8395 -8.29881 -6835 4 49.2486 15.0627 4.66696 -19.7577 20.5705 -9.22457 -6836 4 48.202 14.5739 3.61717 1.65501 39.0327 16.4105 -6837 6 34.3447 6.98096 40.4233 28.1894 -26.1309 -0.966046 -6838 4 33.5941 7.1072 39.8443 -1.28272 -2.58724 -7.46065 -6839 4 35.0352 6.39393 39.9745 -30.768 20.5054 8.50532 -6840 6 41.3452 3.36617 16.9999 -11.8967 -16.9054 2.63506 -6841 4 41.0249 2.72492 17.6694 2.1854 6.18106 -7.89089 -6842 4 41.9449 3.92974 17.49 7.08552 9.22633 4.28017 -6843 6 48.4488 20.6937 14.5344 36.1561 -40.2628 27.2518 -6844 4 47.9962 21.3635 14.0898 -25.7182 45.1623 -29.349 -6845 4 49.3977 20.8911 14.4834 -7.22111 0.680744 -3.09477 -6846 6 52.5006 28.1422 37.1181 -0.438891 10.9489 1.55023 -6847 4 53.461 28.2559 37.0441 -2.53591 -5.73983 -7.32344 -6848 4 52.1579 27.9957 36.2188 6.05301 2.29627 6.02383 -6849 6 53.8778 18.5596 18.7916 -16.4261 -54.6782 2.06415 -6850 4 54.6924 18.1462 18.492 5.89253 -2.608 -0.931268 -6851 4 54.0684 19.4623 18.7843 11.279 55.5152 0.463912 -6852 6 40.9954 39.1455 28.7887 -28.6383 -4.85259 53.4888 -6853 4 41.3933 39.2419 27.9663 30.849 7.00679 -57.5311 -6854 4 40.0484 39.2316 28.6375 -4.32997 -1.25138 -0.266272 -6855 6 38.2708 8.75593 24.2289 27.2886 -4.9888 -5.43324 -6856 4 39.2171 8.59021 23.9715 -26.3742 3.09491 7.04217 -6857 4 38.3303 9.34105 24.9905 -3.83131 2.71498 5.53525 -6858 6 2.99948 29.1469 9.63392 26.6909 -34.1608 2.5373 -6859 4 2.51216 28.7995 8.89273 -4.75194 -2.8028 -9.24178 -6860 4 2.58111 29.9575 9.82954 -15.8869 33.6035 13.3424 -6861 6 27.5773 29.2771 18.3181 4.27818 -11.5166 33.1226 -6862 4 26.7531 29.1546 17.8331 -9.3021 -0.872639 -4.78576 -6863 4 27.3558 28.9731 19.2647 9.0806 12.9475 -44.783 -6864 6 11.8527 21.1658 10.1208 3.44892 -32.1211 19.512 -6865 4 12.1978 22.0146 9.89711 8.39983 22.4635 -8.03232 -6866 4 12.4593 20.8304 10.8135 -12.0936 9.66798 -13.0295 -6867 6 16.8988 32.3014 0.299949 1.29982 1.68058 -0.586211 -6868 4 17.7043 32.7282 0.600499 13.9817 -1.747 3.00212 -6869 4 16.3216 33.0562 0.17902 -12.1561 7.80428 -5.7129 -6870 6 1.309 17.4831 22.5447 23.3848 -11.3219 -15.6007 -6871 4 1.13597 16.5744 22.1718 3.15619 19.2398 8.80125 -6872 4 2.27868 17.6899 22.4311 -25.7511 -7.40397 3.71946 -6873 6 41.5587 6.87311 29.3039 4.08196 29.5448 1.53382 -6874 4 41.6919 5.95311 29.5356 2.80206 -5.98386 3.69024 -6875 4 41.9106 7.40602 30.0483 -3.99043 -10.4039 -5.51054 -6876 6 10.5167 10.7886 13.8618 17.7458 -17.1897 13.2051 -6877 4 10.6632 11.2096 13.003 1.79898 0.261401 -4.84225 -6878 4 11.2159 10.1 14.0373 -16.1376 17.4326 -7.31573 -6879 6 39.8332 15.4952 40.8309 13.3581 4.75609 3.89566 -6880 4 39.9392 16.0809 40.0548 0.3292 -3.56753 7.15077 -6881 4 40.6564 15.5643 41.3732 -15.0531 5.58747 -11.8726 -6882 6 26.5094 19.6057 40.5003 9.17758 -2.41024 9.24949 -6883 4 27.4312 19.885 40.5187 -1.32295 2.31326 -8.74715 -6884 4 26.4504 19.08 41.3172 -10.7617 -0.025449 -2.36491 -6885 6 54.0331 8.19348 13.7645 20.1265 23.4755 -3.20859 -6886 4 54.5379 7.42769 14.0195 10.1236 -9.46733 3.3174 -6887 4 53.1635 7.89609 13.5919 -33.2862 -9.18344 -4.84573 -6888 6 15.685 25.3343 10.6639 3.77823 -5.01457 0.699023 -6889 4 15.2925 25.3549 9.7704 -6.94194 -0.507815 8.78718 -6890 4 14.9859 25.2981 11.3464 3.26271 -0.250944 -15.837 -6891 6 18.6044 3.42728 21.9359 54.0117 -4.17358 13.1129 -6892 4 19.6007 3.50499 22.1915 -55.8621 -1.2706 -18.0159 -6893 4 18.5414 3.70523 21.0018 -0.6471 0.781857 10.4283 -6894 6 50.8906 20.6382 18.514 19.322 19.8933 14.7131 -6895 4 50.0771 21.0514 18.1693 2.40506 3.30677 2.13188 -6896 4 51.4314 21.2881 19.0676 -26.3068 -18.4046 -20.3942 -6897 6 53.3692 20.9044 31.2861 -2.87581 -0.0590227 -4.61483 -6898 4 53.3163 20.8663 32.2507 -1.10677 -1.05899 -2.14121 -6899 4 52.4655 20.8115 30.924 8.48272 0.484508 7.85381 -6900 6 52.8175 27.637 28.9992 -34.1073 -16.3293 -5.23745 -6901 4 52.1753 27.4604 29.7292 18.9476 13.4611 -8.14668 -6902 4 53.5412 28.184 29.256 17.7352 16.912 19.7012 -6903 6 33.3098 15.691 11.3293 10.3241 5.44869 29.2776 -6904 4 33.5439 15.9761 12.2647 -8.49351 -12.0766 -30.078 -6905 4 32.4682 16.1118 11.1139 -1.38634 1.49203 3.14806 -6906 6 20.3823 26.792 27.4754 10.6616 14.7237 17.2289 -6907 4 19.6846 27.4135 27.2507 -4.69437 -0.849554 -6.03625 -6908 4 20.895 27.2908 28.1563 -10.3656 -18.3754 -15.2612 -6909 6 8.54404 2.05454 14.1651 1.1449 13.7122 2.29602 -6910 4 8.12946 1.19872 14.2191 -6.02545 -13.9865 0.607463 -6911 4 8.06484 2.58201 14.8308 4.74922 -3.38849 -5.44478 -6912 6 40.1105 7.56396 40.6794 -0.469697 6.72942 -1.63666 -6913 4 39.7195 8.28533 41.2425 20.0171 -18.0739 -7.27063 -6914 4 40.8018 7.03949 41.1472 -13.6242 13.5344 3.71207 -6915 6 6.897 6.83213 10.7811 7.71606 15.0782 -3.77655 -6916 4 7.19774 7.75246 10.6132 -6.74961 -17.2243 4.00207 -6917 4 7.00156 6.6927 11.7358 -2.06706 0.697676 -4.80225 -6918 6 31.2469 6.57665 20.133 15.2512 -44.8317 5.05575 -6919 4 30.6435 5.99888 20.634 -3.65198 3.16249 1.16613 -6920 4 30.7682 7.35458 19.9689 -22.0921 35.6742 -6.0398 -6921 6 54.5384 21.0446 27.3066 23.2273 -48.3206 40.5729 -6922 4 0.0992734 20.2122 27.4067 -21.2046 24.987 7.15799 -6923 4 54.6588 21.2398 26.4073 -2.82622 20.9035 -45.5707 -6924 6 4.74298 23.1434 16.2203 -30.2995 19.4891 -12.6787 -6925 4 4.36556 24.0555 16.215 7.46998 -18.526 0.357752 -6926 4 5.49124 23.2367 16.7883 23.1348 -5.45784 14.6166 -6927 6 25.5466 11.0338 14.8277 10.3359 0.700294 4.3384 -6928 4 26.1246 10.3443 15.2243 -8.70528 11.4294 -11.7317 -6929 4 25.9183 11.8873 15.0941 -0.865353 -5.34287 -3.41216 -6930 6 41.1962 41.784 29.9422 -30.017 -5.50367 -10.8152 -6931 4 40.9141 40.905 29.5845 10.5201 22.1914 8.67773 -6932 4 40.3904 0.453034 29.9085 19.4524 -11.6054 2.3136 -6933 6 52.2783 15.2862 41.6211 7.07203 -4.19206 -10.8941 -6934 4 51.9431 15.9476 0.307056 -1.67854 11.1856 8.97788 -6935 4 51.5699 14.6487 41.5543 -8.05659 -11.9472 -4.98288 -6936 6 37.758 21.7866 37.8526 10.4754 12.291 4.40187 -6937 4 37.8833 20.8525 37.7239 2.64231 -18.5298 -3.43162 -6938 4 38.1062 21.9123 38.7409 -0.189838 4.59809 2.45253 -6939 6 23.846 9.72877 27.5599 -20.0483 -53.0743 -18.3837 -6940 4 23.7508 8.9538 26.878 9.78252 41.145 35.6193 -6941 4 23.2758 9.50619 28.3397 9.82275 7.24107 -18.911 -6942 6 43.0179 28.0371 32.8168 -8.27592 12.0689 -0.875134 -6943 4 42.8326 27.1827 33.2413 14.9994 1.75302 -2.99965 -6944 4 43.9358 28.1723 32.5349 -8.32605 -13.2452 6.20231 -6945 6 34.1493 21.223 11.895 -6.4617 -26.4803 6.62596 -6946 4 33.7114 20.3967 12.2433 5.74917 23.5867 -12.2191 -6947 4 33.6625 21.5015 11.0997 -1.34318 -2.64619 5.02085 -6948 6 10.5048 31.8203 10.0934 3.12763 27.8567 -5.97475 -6949 4 10.8893 32.6663 10.3856 -2.25958 -16.5293 2.97323 -6950 4 10.042 32.0955 9.27903 1.62317 -10.8132 6.61598 -6951 6 35.8582 37.1311 22.1219 17.442 6.8165 -15.3109 -6952 4 36.7754 37.4644 22.0121 -13.2022 -8.29883 -6.66499 -6953 4 35.6795 37.2674 23.0383 -11.5038 0.0185045 25.2366 -6954 6 27.2889 4.59659 27.4585 -59.4895 -12.2555 32.2126 -6955 4 27.8503 4.63259 28.2407 7.94553 1.46958 -1.61102 -6956 4 26.3513 4.38137 27.8533 49.6255 8.2673 -26.6042 -6957 6 39.0071 22.2889 10.6559 -18.7539 6.55471 8.53947 -6958 4 39.6145 22.0219 9.97399 11.0637 -4.63202 -10.5583 -6959 4 38.132 22.2267 10.2407 1.98377 -6.13574 3.6668 -6960 6 30.7475 39.195 10.9378 13.4076 -25.4475 -2.13886 -6961 4 31.7135 39.1987 10.9202 1.84768 25.2682 1.10777 -6962 4 30.6542 38.2342 10.8274 -15.9936 9.0572 -1.5893 -6963 6 44.6038 26.9469 2.19596 -3.02312 -2.7981 0.496435 -6964 4 44.789 26.0668 2.58199 4.34993 15.1048 -14.5643 -6965 4 45.3477 27.2287 1.63769 1.54159 -5.20589 8.29494 -6966 6 23.7761 14.5574 26.4892 -1.60295 28.5342 -20.4107 -6967 4 23.6176 15.1119 25.659 4.49284 -25.3407 28.839 -6968 4 23.2395 13.7622 26.4238 -2.18231 -2.53609 -2.40557 -6969 6 38.3444 13.3746 39.6516 36.4054 -1.80378 3.51049 -6970 4 39.1202 13.8805 40.0461 -33.1028 -11.4882 -12.1373 -6971 4 37.5326 13.855 39.8351 -2.35218 5.60767 6.28087 -6972 6 17.8972 17.2344 29.4073 9.50877 -9.96512 10.1834 -6973 4 17.6974 16.8197 28.5593 -3.90288 0.722299 -3.3346 -6974 4 17.259 17.9348 29.5179 -13.7448 8.39178 0.729907 -6975 6 17.4263 29.84 9.91085 4.63967 13.4244 18.4952 -6976 4 16.5241 29.7155 9.63978 -6.68442 -7.79832 -10.641 -6977 4 18.0121 29.6473 9.18714 6.17675 -5.88453 -9.84082 -6978 6 35.6257 6.05657 19.614 -2.53427 -7.67526 1.74575 -6979 4 35.1442 5.56448 18.9178 7.07991 15.7277 0.668344 -6980 4 35.8526 6.94177 19.2847 -2.44106 -6.98166 -5.33042 -6981 6 18.6731 22.2952 17.5195 -8.35574 4.99894 -0.254983 -6982 4 17.7298 22.4259 17.6349 -7.1371 0.699885 10.6378 -6983 4 18.7532 22.3981 16.578 9.97204 2.32932 -16.3296 -6984 6 20.0126 3.82895 32.2846 -5.38506 7.6032 10.998 -6985 4 19.7316 4.05659 31.3951 3.95105 0.959407 -6.40709 -6986 4 20.9087 3.45699 32.2166 -3.62371 1.18893 -2.87546 -6987 6 5.48106 6.97474 8.11911 -13.3431 -28.5569 -4.23146 -6988 4 5.76723 7.87539 8.05126 9.5873 19.9723 5.64469 -6989 4 5.84003 6.56862 8.91875 4.365 4.20298 7.41399 -6990 6 44.2055 20.527 25.594 -36.5422 -32.7496 -22.1294 -6991 4 44.4952 21.1964 26.2048 27.2712 12.1663 0.509182 -6992 4 44.8136 20.1687 24.9192 13.264 16.717 13.5958 -6993 6 43.9676 36.9898 17.8707 9.43563 13.9581 11.3899 -6994 4 44.6425 37.4866 17.3506 -13.9886 -14.2814 1.04264 -6995 4 43.5166 36.316 17.3518 1.57776 -4.71986 -9.07493 -6996 6 34.624 10.1249 16.2553 -3.80507 -0.870494 -23.8528 -6997 4 34.4029 10.0232 15.2766 7.60873 7.05542 33.3523 -6998 4 34.6485 11.0843 16.4397 0.136369 -4.79707 -6.11079 -6999 6 23.6588 3.43472 1.31587 2.0947 2.20184 -10.1691 -7000 4 23.5283 2.45383 1.23665 3.68597 29.2686 -10.0862 -7001 4 23.7829 3.95594 0.465507 -5.48879 -27.0668 21.3429 -7002 6 33.408 38.9514 5.0951 12.9752 29.4037 8.61745 -7003 4 33.0296 38.079 4.95882 -18.4714 -2.71742 3.9597 -7004 4 32.7559 39.6696 5.33685 4.56028 -29.4715 -9.24259 -7005 6 22.5612 32.5054 35.7914 -7.59797 17.3543 -6.08959 -7006 4 23.434 32.1498 35.9581 8.59623 -0.183209 1.98348 -7007 4 22.6598 33.4814 35.6698 2.01652 -18.126 2.22848 -7008 6 32.4197 37.2669 13.8205 20.7322 22.1346 -9.91782 -7009 4 31.6112 36.8955 13.5272 -29.3682 -10.7083 -8.61391 -7010 4 32.7793 36.5983 14.3861 8.71878 -17.2052 10.8721 -7011 6 52.6061 12.7509 39.5955 -8.08982 -5.36768 -0.728302 -7012 4 53.2357 13.3696 39.2333 6.80499 9.05338 -6.44134 -7013 4 53.0752 12.2813 40.2869 4.34006 -2.9945 3.85342 -7014 6 28.8406 14.5639 1.22393 13.2702 13.2594 -7.07732 -7015 4 28.2547 13.832 1.29641 -8.98786 -23.9917 -3.18497 -7016 4 28.3081 15.2705 1.57856 0.691728 8.20301 3.76967 -7017 6 1.46371 32.4171 23.3808 -12.1734 -25.5645 13.9938 -7018 4 1.52421 31.5049 23.0145 7.51613 19.861 -1.66683 -7019 4 1.90409 33.05 22.8306 10.4998 5.06095 -20.3958 -7020 6 54.3326 23.3294 28.9734 2.61182 15.3833 -1.51239 -7021 4 54.2696 22.9227 29.8387 -0.130455 -4.55084 5.05008 -7022 4 54.4476 22.6226 28.3359 -0.0534198 -9.82677 -0.516761 -7023 6 14.3165 12.143 35.6759 -19.2415 -8.81627 -0.503167 -7024 4 14.3877 12.7977 36.3527 0.233596 18.6669 11.2481 -7025 4 15.2077 11.8775 35.5438 25.0768 -7.98239 -7.51161 -7026 6 18.9926 6.51479 41.2701 -28.9824 -29.6237 1.81046 -7027 4 18.266 5.84223 41.3522 13.7729 17.3268 -5.20094 -7028 4 19.3309 6.57432 0.258232 8.64619 7.1183 4.95474 -7029 6 5.3156 17.8978 20.3375 -21.1545 16.5991 3.60383 -7030 4 4.72623 18.3448 19.6879 4.29754 -5.05212 8.41069 -7031 4 4.82948 17.9368 21.1935 9.1049 1.98802 -15.8618 -7032 6 24.7216 34.9676 30.1666 -3.07326 -14.2394 -14.8574 -7033 4 24.8542 35.9126 30.1802 4.14387 12.0412 4.3338 -7034 4 24.7023 34.7085 29.2239 -0.0690866 8.67132 12.606 -7035 6 31.8759 4.61762 18.1838 16.2734 -6.94643 -1.61547 -7036 4 31.7767 5.32612 18.8146 -0.693712 9.66586 8.6442 -7037 4 30.9961 4.53608 17.8264 -12.7431 -2.99311 -6.3499 -7038 6 8.70679 17.4876 5.93376 -7.2594 15.0659 3.57914 -7039 4 7.94553 18.1226 5.84491 19.4684 -9.25267 2.2845 -7040 4 9.55198 17.9922 5.98984 -15.4384 -2.82622 -0.0668602 -7041 6 29.8338 10.9771 14.4736 2.85583 -20.8689 4.17621 -7042 4 29.3487 11.4359 13.7779 -2.35633 12.0716 2.99849 -7043 4 29.9333 11.5067 15.2792 -5.11986 9.15119 -1.36774 -7044 6 48.7176 10.2992 32.5766 37.752 -4.2965 -7.5649 -7045 4 48.6861 9.98692 33.5109 4.36425 8.41374 -15.5521 -7046 4 49.6689 10.1741 32.2115 -43.6207 3.75412 17.6406 -7047 6 8.33261 15.6868 37.8739 25.2856 -16.7599 -34.932 -7048 4 8.10095 16.0156 38.719 -17.2941 17.7495 29.2541 -7049 4 7.84865 16.1686 37.1872 -4.77393 6.83012 10.4818 -7050 6 50.4 3.07893 17.326 6.75193 2.54677 -10.5223 -7051 4 49.8476 3.08454 16.5614 0.0537611 0.514048 -24.7797 -7052 4 49.7563 3.22783 17.9993 -5.52918 6.4504 35.6689 -7053 6 14.6925 38.3995 10.8943 -10.4545 -11.2686 -1.07851 -7054 4 14.3539 38.6226 11.7634 0.533319 14.8424 10.3104 -7055 4 14.2274 37.5681 10.7419 5.82896 -0.087222 -8.72758 -7056 6 34.1157 6.37736 10.827 20.4112 17.5403 9.63945 -7057 4 34.1356 7.15575 10.2337 -4.79421 -13.4894 2.09643 -7058 4 34.9392 6.47467 11.3721 -17.4677 -2.57189 -8.67394 -7059 6 7.16428 37.5549 17.6272 35.8206 -6.94283 1.42456 -7060 4 8.17672 37.4379 17.5039 -45.4701 3.04153 9.54579 -7061 4 6.9329 37.0909 18.4673 4.48983 7.2965 -12.9876 -7062 6 51.5173 11.3068 16.7982 -29.6345 12.4732 -19.9425 -7063 4 52.2329 10.8476 17.1999 24.0623 -16.8016 7.00331 -7064 4 51.4947 11.1437 15.8343 5.46468 -1.37513 9.57578 -7065 6 15.6604 8.64432 3.1895 3.55656 -13.2601 -18.336 -7066 4 15.3831 9.26805 3.84437 -11.3932 20.6181 15.5674 -7067 4 16.2117 8.03967 3.68493 6.317 -8.49687 -0.892024 -7068 6 5.4241 21.4549 11.925 7.11554 10.6798 -7.02681 -7069 4 5.33432 22.3429 11.4717 -4.65036 -17.889 17.4658 -7070 4 4.77116 21.2815 12.6313 -0.367847 15.68 -7.67111 -7071 6 50.1893 24.0442 37.9781 -13.1484 0.855785 -17.0816 -7072 4 49.5179 24.1845 37.2801 8.13829 0.111989 16.6227 -7073 4 50.739 23.3224 37.6715 2.2014 -1.01472 3.1635 -7074 6 39.7382 11.2507 31.6977 23.6406 7.23187 -3.58891 -7075 4 40.4046 11.8538 31.2923 -18.8268 -10.2166 5.80002 -7076 4 38.8713 11.6238 31.5229 -1.54541 8.70996 -4.13134 -7077 6 26.6923 10.8294 20.5841 1.50171 17.3672 -0.163562 -7078 4 26.3063 11.3901 21.299 5.00814 -17.7696 -11.6362 -7079 4 26.5519 9.91114 20.8376 -1.99146 -0.979444 5.82041 -7080 6 12.5744 17.5779 18.1705 9.62673 -31.396 -11.9521 -7081 4 12.2909 16.663 17.987 19.11 1.74385 -8.92353 -7082 4 11.8345 17.8227 18.6757 -30.0259 29.7826 25.4081 -7083 6 47.7778 31.6094 17.3292 -7.10666 -17.038 -8.06235 -7084 4 48.347 31.2547 18.014 2.28217 1.30733 4.94459 -7085 4 47.3418 30.8212 16.9416 1.10301 17.3121 -1.07651 -7086 6 1.06524 3.39018 18.5298 -14.3894 10.3619 10.5476 -7087 4 1.40487 3.81402 19.3241 14.4239 4.64695 -0.395869 -7088 4 0.13491 3.28998 18.7837 -2.56119 -4.67364 -10.5163 -7089 6 26.5953 20.387 15.3121 4.86749 -24.5982 -5.101 -7090 4 27.0693 19.5476 15.0746 -6.18915 17.8108 6.48343 -7091 4 25.6882 20.059 15.4501 7.15985 4.40883 -1.86988 -7092 6 42.0068 3.03472 36.7639 -8.02624 -14.3838 3.82934 -7093 4 41.5138 2.21919 36.6422 -1.8797 -9.24856 -19.1073 -7094 4 41.9017 3.12445 37.6992 6.42334 14.3979 20.8626 -7095 6 39.3283 22.4329 33.1866 16.7976 22.9312 16.1168 -7096 4 39.617 22.6043 34.1233 -9.1007 -15.4059 -24.4851 -7097 4 39.2996 23.351 32.8579 -1.9326 -13.3537 -7.72798 -7098 6 18.5014 34.9723 11.9503 -40.872 8.93582 -22.0032 -7099 4 19.313 34.895 12.3871 37.9781 -3.12322 33.9295 -7100 4 17.8134 35.1232 12.6133 -0.0311416 1.40314 8.7121 -7101 6 22.862 14.1089 0.203393 17.2545 -2.37957 19.5806 -7102 4 23.1276 14.8054 41.5255 0.219481 9.03583 -13.3452 -7103 4 23.4003 14.3117 0.999915 -8.23864 -6.67581 -7.59618 -7104 6 30.9898 16.6325 33.7811 -26.24 4.82889 -18.7278 -7105 4 30.4991 16.9295 32.9906 -1.06726 -7.21679 15.5744 -7106 4 31.8724 16.8786 33.545 20.2345 1.84197 6.64809 -7107 6 28.4142 35.5086 5.55132 5.25795 11.5001 -0.86936 -7108 4 29.133 34.8901 5.6729 7.87573 -11.0207 0.32142 -7109 4 28.8444 36.3678 5.44284 -5.96253 -1.38672 0.306744 -7110 6 2.06178 31.4487 10.6522 7.7724 2.5252 5.43788 -7111 4 2.46787 32.1741 10.1582 1.48866 -1.05725 0.00513454 -7112 4 1.12423 31.5492 10.4902 -10.7705 -1.69396 -4.48797 -7113 6 5.96168 9.75465 21.3469 -3.89643 8.81348 -50.5901 -7114 4 6.28958 10.5041 20.7544 -9.04712 -29.7196 22.9081 -7115 4 5.37557 9.21645 20.7377 15.5825 17.9805 22.1648 -7116 6 24.7784 26.6095 2.66066 11.1746 -2.24162 5.28408 -7117 4 23.9956 26.7754 2.10108 -2.29597 -10.0774 9.56872 -7118 4 24.6953 25.8682 3.30791 -10.2989 11.7132 -14.8816 -7119 6 45.7373 4.24983 18.6143 27.3178 -0.763462 -4.2154 -7120 4 46.5067 4.85242 18.4954 -19.0177 -2.03966 3.70694 -7121 4 46.1538 3.38182 18.4484 -14.6954 3.88493 3.6473 -7122 6 4.46307 0.776675 15.9004 -0.0751459 19.7124 -7.24544 -7123 4 4.28648 41.7452 15.8506 7.90268 -11.6504 4.49907 -7124 4 5.34722 0.941656 16.2766 -7.84 -9.44871 -1.18019 -7125 6 2.43543 19.4835 25.3975 -8.02289 7.34849 22.5637 -7126 4 1.8039 19.0427 26.0095 9.34608 -2.48106 -16.7091 -7127 4 2.63666 18.9452 24.6346 -2.8512 -10.1259 -3.82486 -7128 6 40.5893 8.48301 5.11314 -1.35782 -12.8068 -2.32465 -7129 4 40.7524 9.27543 5.61119 -3.30667 17.7402 10.4879 -7130 4 41.4486 8.05286 5.16027 3.34022 -8.8045 -8.92488 -7131 6 49.3107 22.3512 41.5276 -10.6582 56.3201 6.76971 -7132 4 48.577 22.7852 41.0387 15.264 -8.60422 5.01334 -7133 4 49.2575 21.458 41.2835 -0.448838 -46.7272 -11.6484 -7134 6 0.358901 40.9209 20.5803 -19.8443 -5.20423 -21.0143 -7135 4 0.209912 39.9476 20.5616 0.00996972 10.506 -0.843682 -7136 4 54.6254 41.351 20.0384 15.1519 -13.0167 14.2251 -7137 6 34.868 15.3449 38.0159 -4.77394 11.9701 -21.6163 -7138 4 34.21 16.0699 37.905 14.1938 -11.5268 -7.28032 -7139 4 35.478 15.4115 37.2329 -18.0572 6.07255 16.3223 -7140 6 7.76403 26.0071 29.8556 5.34791 -0.957035 4.21351 -7141 4 8.62364 26.4528 30.0224 -8.82329 -12.5157 -0.945539 -7142 4 7.90301 25.0604 30.0866 1.23738 19.4493 -2.25897 -7143 6 40.714 22.798 20.4449 30.2403 28.6605 -20.1452 -7144 4 41.3584 23.4838 20.081 -22.4198 -29.1089 11.875 -7145 4 40.2102 23.3285 21.0558 -12.075 4.18803 12.4472 -7146 6 37.6868 25.6422 36.0641 6.66209 -5.59755 13.6904 -7147 4 38.2808 24.8923 36.0269 4.65063 -3.44496 7.57849 -7148 4 37.3429 25.6351 35.1859 -16.0941 8.70932 -25.1352 -7149 6 5.45062 23.9828 10.2587 5.16865 5.9624 5.01697 -7150 4 5.97911 23.8188 9.45867 -6.21725 4.51436 8.29683 -7151 4 5.82702 24.8173 10.6422 -10.2102 -24.7042 -13.9856 -7152 6 48.3972 21.0585 38.1887 36.079 14.8531 -15.9941 -7153 4 48.9083 20.6932 38.9203 -9.15007 -3.24726 4.47194 -7154 4 49.1186 21.3212 37.5505 -33.8036 -6.43701 14.9947 -7155 6 15.2894 25.0118 3.53737 -15.5341 -16.8072 10.9824 -7156 4 15.3523 24.0463 3.54635 7.80908 -0.218079 -10.1213 -7157 4 14.6524 25.152 4.25109 -0.971191 12.1275 -1.41446 -7158 6 46.3973 40.2818 20.0864 -5.10979 -28.8528 0.810189 -7159 4 46.7099 39.3289 20.1836 -4.69047 35.7762 -3.66479 -7160 4 47.1343 40.8792 20.2285 11.4236 3.93541 -0.385178 -7161 6 34.6613 36.4755 0.335066 -24.7851 30.4749 -21.6933 -7162 4 34.8743 36.0541 1.15687 -4.43901 -4.57192 24.0914 -7163 4 33.7851 36.9546 0.454416 30.1492 -20.7825 2.99091 -7164 6 52.5881 7.99834 30.4195 9.51271 -12.4348 0.483116 -7165 4 52.1042 8.76616 30.7719 -8.49213 -7.21741 -10.9068 -7166 4 52.0722 7.46347 29.7764 0.520668 12.6171 10.1624 -7167 6 32.0714 3.86484 29.4697 -9.7538 -17.9077 -31.6249 -7168 4 31.6702 2.97314 29.6052 7.93851 20.6113 2.31556 -7169 4 32.0839 3.94733 28.4741 0.539668 -3.17995 32.4864 -7170 6 20.3786 17.8365 28.6466 -12.59 16.0252 -12.2548 -7171 4 19.5397 17.5939 29.0718 10.0495 1.57584 1.91854 -7172 4 20.0545 18.3008 27.843 10.529 -6.18443 10.1885 -7173 6 30.4085 41.1704 41.0135 6.18506 -3.22706 -14.2809 -7174 4 30.53 40.7341 40.1581 -10.3332 2.11637 -0.589059 -7175 4 31.2241 40.9477 41.4498 10.7912 2.88832 12.9661 -7176 6 35.4567 32.8541 27.9296 20.1033 20.3116 -25.2142 -7177 4 35.1103 33.2872 28.7174 -1.27312 4.66796 4.01126 -7178 4 35.9087 33.5476 27.342 -15.0191 -24.2746 21.4934 -7179 6 14.3794 6.67806 12.7301 -1.9413 28.2373 -4.00169 -7180 4 15.2373 6.26429 12.8613 2.01848 -2.11516 -0.858514 -7181 4 14.5332 7.65903 12.7289 -3.54891 -27.4927 -2.87641 -7182 6 41.884 41.5441 20.3292 17.5267 3.97767 -7.39307 -7183 4 42.6467 41.3531 19.7473 -6.80228 5.43899 6.41045 -7184 4 41.2989 40.8038 20.1922 -8.54368 -4.96293 -3.75352 -7185 6 46.4016 22.5784 8.86191 7.75251 -10.6521 7.11129 -7186 4 45.8476 21.8716 8.52158 -12.3576 2.35246 -8.51817 -7187 4 47.0146 22.0703 9.39636 1.75986 6.35736 5.22437 -7188 6 17.4049 20.6472 13.8946 9.03444 14.2526 1.49725 -7189 4 17.6929 21.5842 14.0543 -8.3446 -25.4959 -7.46489 -7190 4 17.3265 20.4984 12.9333 2.034 6.01629 5.63707 -7191 6 8.18883 9.49722 13.352 -36.2403 7.79383 -0.838203 -7192 4 7.38606 10.0563 13.5919 32.9103 -12.129 -3.09847 -7193 4 9.02271 9.90793 13.6245 -5.40631 9.4956 5.41337 -7194 6 7.5857 14.8045 29.5864 0.660595 8.18183 -2.22865 -7195 4 7.08502 14.4366 30.3218 -1.52277 2.83209 3.37304 -7196 4 7.02502 15.474 29.1565 2.15616 -5.78955 1.98978 -7197 6 29.5787 39.2199 22.642 -23.9064 2.77655 4.40715 -7198 4 29.7923 38.7231 23.4359 12.3113 -5.95711 5.92816 -7199 4 30.3289 39.2945 22.0576 16.6647 -3.01011 -3.30282 -7200 6 19.7261 28.8048 8.43629 7.07867 10.1416 -1.30332 -7201 4 19.5094 27.8711 8.56662 5.24428 2.50367 -2.7317 -7202 4 20.6808 28.8901 8.64157 -12.3267 -4.04756 -0.658665 -7203 6 20.0918 21.6433 25.9098 -22.8378 18.9737 -2.62589 -7204 4 20.6828 21.9331 26.6394 -14.5657 0.991195 -11.6344 -7205 4 19.2872 22.2354 25.9429 24.6623 -16.2361 5.64257 -7206 6 12.7798 16.1171 22.7918 2.83481 -1.66518 -8.4999 -7207 4 12.1052 16.761 22.5802 -5.26913 11.1277 0.000470885 -7208 4 12.4145 15.3113 22.3987 5.67676 1.62415 3.74644 -7209 6 7.09341 27.2127 17.9852 -17.6727 17.6357 -2.43489 -7210 4 7.71878 26.5086 17.8851 15.5779 -18.3258 -2.50971 -7211 4 7.24623 27.7931 17.2297 2.82114 0.873921 -0.89624 -7212 6 32.4121 8.69011 34.8574 -11.3856 31.068 25.9423 -7213 4 32.686 9.10208 35.716 -2.62469 -14.8204 -24.695 -7214 4 31.4981 9.04705 34.7249 20.8054 -13.4625 -4.53694 -7215 6 50.3489 28.2274 17.5408 2.96892 -19.9668 3.87059 -7216 4 50.2931 27.3328 17.9381 -3.71715 13.2344 -0.552608 -7217 4 51.012 28.0828 16.8476 -2.81747 8.99858 -3.49204 -7218 6 15.6752 32.1523 25.7996 -24.1097 -1.02752 -8.0065 -7219 4 16.4469 32.5721 26.1513 19.1192 7.47953 7.03048 -7220 4 15.1241 32.8942 25.4834 5.39501 -5.59697 3.80799 -7221 6 41.2942 22.0009 29.6469 23.8016 -11.3242 12.4312 -7222 4 40.6197 22.5451 29.2897 -20.6362 19.5621 -14.8771 -7223 4 40.8321 21.2604 30.0334 -1.27155 -6.80964 4.85239 -7224 6 24.5512 12.7478 8.87624 0.539479 -2.56763 -16.1827 -7225 4 24.2317 13.5544 9.29419 1.48927 0.294937 0.678301 -7226 4 24.2485 12.8104 7.9491 4.47413 -5.17195 11.4459 -7227 6 47.3043 20.1171 10.4067 20.0451 13.2477 8.4905 -7228 4 48.2327 20.3756 10.3708 -0.951507 4.56311 9.88278 -7229 4 47.2371 19.5522 9.64912 -14.6685 -17.4861 -17.2657 -7230 6 17.6686 14.2187 29.9453 7.31834 -6.07886 -8.28437 -7231 4 16.8567 14.6777 30.1627 -12.3548 11.6861 -0.426412 -7232 4 18.1621 14.7508 29.3045 -6.68566 0.573373 4.02912 -7233 6 21.3468 34.5864 28.5404 1.3464 21.7174 -7.002 -7234 4 21.5866 35.4807 28.2285 -6.04705 -7.23946 1.73439 -7235 4 21.8012 34.5133 29.372 6.90897 -8.71765 12.9147 -7236 6 35.0919 4.05058 4.01374 -15.5825 9.30565 11.5721 -7237 4 34.2387 3.74233 4.43927 22.4566 16.9059 -11.4445 -7238 4 35.1406 5.04582 3.93988 -11.3656 -25.7387 7.52347 -7239 6 29.9083 8.58745 22.5962 -15.8002 1.46007 -28.7439 -7240 4 29.4293 8.33193 21.7391 23.5037 3.33824 36.5279 -7241 4 30.4512 7.83881 22.8901 -6.5033 3.48596 -7.29863 -7242 6 9.80484 32.9578 15.933 -3.40746 -8.77641 -12.0557 -7243 4 9.78146 31.9986 16.1651 13.0086 23.7442 4.23133 -7244 4 10.4547 33.4728 16.4465 2.19651 -19.1398 5.78046 -7245 6 24.9207 14.2283 32.5839 15.8568 -2.03515 22.8032 -7246 4 25.4679 14.491 33.3602 -10.7028 -6.65113 -14.6818 -7247 4 24.5651 15.0495 32.2637 -5.99659 7.67207 -7.30645 -7248 6 49.6599 21.9679 26.2292 42.3899 27.0609 3.31449 -7249 4 50.4576 21.5325 26.6526 -24.3124 13.7703 -9.69582 -7250 4 49.9726 22.89 25.9802 -16.6307 -33.6109 8.97028 -7251 6 39.2146 29.6271 28.776 1.2649 -6.72815 -4.66326 -7252 4 39.3113 29.0399 29.5368 -1.10705 1.67847 4.24024 -7253 4 39.5646 29.0864 28.052 -0.275695 2.9096 0.748968 -7254 6 50.692 34.7829 39.7485 29.9384 -8.83369 -9.14761 -7255 4 51.6379 34.6172 39.5245 -10.9597 10.0847 13.0799 -7256 4 50.284 34.1892 39.1195 -14.598 -6.88033 -5.74908 -7257 6 29.205 20.8761 19.5187 12.6622 -8.88768 18.517 -7258 4 30.1458 21.1462 19.5468 -10.0278 2.51211 -7.13483 -7259 4 28.7621 21.2804 18.7794 -5.02457 12.868 -15.5739 -7260 6 45.8413 1.41619 21.3894 -25.1775 13.0352 -19.0829 -7261 4 45.002 1.0285 21.6935 10.996 -3.183 3.42833 -7262 4 46.5512 0.981978 21.8333 16.3199 -17.0363 14.4799 -7263 6 26.0942 5.84138 12.9755 -8.81801 -1.79204 -2.94978 -7264 4 26.5644 5.00851 12.8396 1.48472 -6.22175 2.21387 -7265 4 25.1658 5.65249 12.7519 4.56693 -2.33816 -1.27821 -7266 6 9.00853 19.0479 23.7214 20.279 18.3012 -13.9253 -7267 4 8.07192 18.8993 23.8406 -12.3386 2.44029 -0.494901 -7268 4 9.09287 19.8709 23.17 -6.05991 -16.4473 11.9144 -7269 6 47.699 14.1778 40.0244 8.37408 5.46764 -8.11648 -7270 4 48.526 14.369 39.5365 -13.6583 -0.0280305 9.55934 -7271 4 47.2742 15.0291 40.2237 1.48315 -6.20176 -4.56159 -7272 6 47.9891 19.7944 0.501942 -52.5058 -34.5194 5.9677 -7273 4 48.5389 19.8149 1.25758 31.4646 9.24384 22.8657 -7274 4 47.3233 19.1101 0.79406 16.1078 24.936 -21.6052 -7275 6 27.1644 39.5895 31.4222 -35.4984 -42.2857 -13.2745 -7276 4 26.8828 40.2644 32.0188 2.45392 19.408 13.0965 -7277 4 26.334 39.0158 31.3353 32.2444 14.87 -2.1562 -7278 6 20.718 15.281 27.2921 -20.5288 29.0824 -25.1338 -7279 4 19.7916 15.5288 27.1303 0.0426049 -12.6319 11.5337 -7280 4 21.1251 16.0883 26.9354 13.4588 -8.377 2.43969 -7281 6 53.2931 3.12982 19.6939 21.059 35.3193 6.93312 -7282 4 52.5111 3.68486 19.642 -0.600406 9.66435 -1.15328 -7283 4 52.9649 2.26115 19.6482 -6.97037 -43.0252 -2.92507 -7284 6 40.7577 33.3874 24.037 12.7176 -1.25655 15.6318 -7285 4 41.575 33.1492 24.5319 -10.6485 3.51614 -11.0419 -7286 4 40.1417 32.64 24.1417 6.01104 2.31945 0.566227 -7287 6 50.2034 37.8915 21.3784 34.5696 42.4783 -9.46203 -7288 4 50.977 37.3667 21.5595 20.6596 -6.9612 4.63629 -7289 4 49.5128 37.3071 21.51 -51.1752 -39.6198 7.18684 -7290 6 41.3315 2.34663 21.9881 -5.34027 -0.787955 22.4754 -7291 4 41.3778 2.5308 21.0564 -4.51788 5.59338 -11.8441 -7292 4 40.4369 2.61524 22.307 16.348 -5.18373 -12.1741 -7293 6 3.68887 21.2797 14.3363 -13.7249 24.7693 -29.296 -7294 4 4.1389 21.9084 14.895 6.09004 12.6164 9.74183 -7295 4 3.85532 20.4521 14.7268 10.1618 -35.5887 19.7816 -7296 6 34.2749 11.1621 36.6211 6.86722 -26.3475 -8.98455 -7297 4 34.1457 10.3739 37.2084 1.76529 18.7936 -6.49638 -7298 4 34.0208 11.9523 37.0887 -10.0392 4.20616 19.2695 -7299 6 24.047 21.9251 23.4534 9.96695 -9.01801 9.45846 -7300 4 24.1056 21.4984 22.592 0.489969 -1.19981 -5.95122 -7301 4 24.6049 21.3417 24.0221 -10.3198 12.7259 -7.25629 -7302 6 18.8859 0.355593 4.41703 6.91373 -0.488994 13.8226 -7303 4 18.8848 41.346 4.15992 -3.4937 -3.21088 -8.69706 -7304 4 19.4141 0.350836 5.23016 -4.89519 7.76131 -7.17368 -7305 6 1.61894 7.82812 17.7388 11.0013 -2.20401 0.0755565 -7306 4 1.69825 6.91132 17.4299 0.598176 5.44338 0.144381 -7307 4 0.751076 7.92867 18.1276 -6.88769 -1.80246 0.772288 -7308 6 9.88357 31.5477 26.4865 20.7425 -47.9078 -25.9665 -7309 4 9.77347 30.8406 25.7562 4.13802 32.2768 29.9214 -7310 4 9.16637 32.1481 26.416 -28.5637 22.827 -5.6847 -7311 6 46.9801 33.0031 20.3665 8.92807 -2.6835 25.0439 -7312 4 47.1906 32.5959 21.2783 -12.5238 7.50902 -41.0074 -7313 4 46.473 32.3868 19.8049 3.08737 -2.68707 12.6131 -7314 6 49.5381 29.29 21.3848 5.35466 4.48298 6.61079 -7315 4 50.3596 28.8237 21.4263 11.6576 -22.6485 -14.6982 -7316 4 49.6544 29.7814 22.1942 -19.8316 15.0268 8.13943 -7317 6 13.5135 31.8933 19.1567 20.4477 19.0535 18.7588 -7318 4 12.9544 32.0303 19.9484 11.7182 -3.51681 -10.2564 -7319 4 14.3688 32.3555 19.4049 -26.6747 -15.4769 -10.5401 -7320 6 46.6242 34.0973 16.9259 3.25439 -22.1556 18.333 -7321 4 46.8986 34.1178 16.0034 3.18051 -0.659651 -5.23437 -7322 4 46.9878 33.2447 17.2966 -6.98741 23.2488 -14.973 -7323 6 19.7685 39.5238 2.42723 -1.93992 9.56528 -9.07466 -7324 4 20.504 40.1421 2.55739 -2.20075 -2.41675 -0.557551 -7325 4 19.2228 39.9982 1.75695 7.86662 -14.3322 13.7479 -7326 6 16.5372 9.39399 28.3106 5.81076 4.55242 0.698497 -7327 4 16.5228 10.3583 28.3138 -6.10914 3.2393 2.1867 -7328 4 17.4567 9.2086 28.1181 8.68803 -11.6531 -1.09187 -7329 6 3.04764 33.3834 8.9498 9.15555 8.47462 14.2626 -7330 4 2.34782 34.0603 8.86882 1.18173 -6.7492 -12.1187 -7331 4 3.16543 32.8691 8.13996 -9.91006 6.39371 -6.60301 -7332 6 49.6799 28.314 0.198287 -24.1009 9.02482 3.02524 -7333 4 50.5864 28.3416 41.8577 25.8797 -1.22492 -6.2647 -7334 4 49.539 27.5375 0.746128 -0.431885 -1.84115 5.43874 -7335 6 1.41501 6.84656 30.491 -4.80497 13.9866 22.936 -7336 4 1.80101 7.66454 30.873 3.64878 -10.2221 -13.1962 -7337 4 0.770406 6.61566 31.1883 9.6026 -0.286793 -13.8716 -7338 6 19.7721 9.41455 33.714 -8.86768 10.4812 -29.5452 -7339 4 19.9336 8.45599 33.7164 -2.74186 3.51224 -8.50186 -7340 4 19.4649 9.70036 32.7878 8.54711 -12.9815 34.2723 -7341 6 26.1689 11.9219 3.60877 17.3014 14.1658 -18.8808 -7342 4 25.6285 12.278 4.29668 -11.0155 5.7348 17.6305 -7343 4 26.0891 10.974 3.64129 -4.70103 -13.8965 4.54114 -7344 6 33.2526 2.15457 18.2061 -11.4346 36.8522 -3.73875 -7345 4 32.7853 2.99777 18.4754 10.6797 -23.9754 -11.6278 -7346 4 32.6748 1.45157 18.4903 -6.58847 -5.37306 4.71859 -7347 6 1.56641 29.1164 15.6218 -13.5802 38.9916 52.9136 -7348 4 0.75332 28.6899 15.9164 -2.28927 1.65734 -1.12046 -7349 4 1.88381 28.6368 14.9104 18.6776 -39.2188 -53.7174 -7350 6 41.7212 4.09992 39.5909 -11.2791 25.9615 -27.213 -7351 4 41.4168 4.81457 38.9155 6.653 -41.6332 33.8875 -7352 4 40.9635 3.53859 39.8438 1.60091 7.46224 -7.31473 -7353 6 28.6931 41.7984 21.1891 -6.68751 -8.42641 -4.80462 -7354 4 29.0735 0.780303 21.3271 9.25035 -16.558 -3.13259 -7355 4 29.3834 41.1221 21.0106 -2.7364 22.7931 4.70591 -7356 6 11.6395 12.4176 35.4525 -19.931 13.6599 -6.89173 -7357 4 11.6974 12.2316 36.3791 0.0383878 -4.43782 22.0781 -7358 4 12.5438 12.3774 35.1867 22.2579 1.64914 -11.6458 -7359 6 9.79005 12.0613 0.287125 39.0331 19.741 15.6941 -7360 4 10.6741 12.3652 0.649112 -24.288 -6.9143 -28.8601 -7361 4 9.37178 11.7496 1.07064 -16.9981 -12.0004 12.0483 -7362 6 48.1738 12.4001 9.21087 -14.7098 16.6281 -3.51107 -7363 4 48.3046 11.757 8.50338 5.36034 -5.93883 0.971929 -7364 4 48.886 12.3441 9.8545 11.7295 -7.72549 2.46367 -7365 6 20.1355 24.3829 18.9522 12.9308 -0.734849 -39.1055 -7366 4 19.4937 23.7815 18.5135 12.9255 8.80461 9.87411 -7367 4 20.8069 24.6162 18.234 -21.1698 -7.06963 26.7537 -7368 6 16.5393 31.2961 16.4761 -1.92172 -19.5246 -12.7122 -7369 4 16.66 32.2288 16.679 -4.64409 4.5232 17.4599 -7370 4 16.1207 30.7474 17.1716 1.36469 17.4989 2.94612 -7371 6 1.78169 14.6393 36.2977 19.9207 14.6923 -9.09136 -7372 4 1.03986 14.2937 35.8105 -15.9251 -7.35249 0.645581 -7373 4 1.68132 14.4688 37.2355 -8.64532 -4.94464 12.0587 -7374 6 4.36624 29.2084 29.5903 15.7403 17.1522 -11.4447 -7375 4 4.94475 28.7816 30.2313 0.42296 -3.8665 4.22363 -7376 4 4.9316 29.8996 29.1557 -19.5902 -17.4666 6.54186 -7377 6 43.6839 0.248111 22.6506 -19.7732 -13.3298 -9.50689 -7378 4 42.8764 0.661685 22.3065 0.028666 2.48852 1.60322 -7379 4 43.5183 41.2016 22.5042 11.2477 10.9397 1.57875 -7380 6 52.4994 40.9828 27.2386 -0.538127 -6.12089 -28.931 -7381 4 52.76 40.8447 26.286 -9.02638 3.90908 21.7421 -7382 4 53.2684 41.4137 27.6303 2.05735 4.02476 1.85103 -7383 6 25.5814 23.8969 27.7396 -24.7861 2.98762 0.531627 -7384 4 24.718 24.3642 27.6072 20.4038 -13.4527 4.15226 -7385 4 26.2821 24.4835 27.457 3.8963 1.45656 -1.88052 -7386 6 23.1228 17.031 33.3243 -5.52517 1.23961 5.4323 -7387 4 23.1399 17.5083 34.1558 0.441881 0.23205 -0.480567 -7388 4 22.8557 16.1383 33.5546 -4.67547 -8.64305 1.56256 -7389 6 2.92722 11.8725 21.3561 -41.4423 -19.1296 -19.7046 -7390 4 2.18606 11.2638 21.6443 29.5918 21.1066 -8.34803 -7391 4 3.54191 11.9259 22.0595 17.1072 -0.484489 21.5157 -7392 6 2.18317 4.15265 30.0257 5.779 -9.3787 -10.7468 -7393 4 2.12921 5.11001 30.0802 -2.76576 12.2821 -0.843831 -7394 4 2.67493 3.96573 29.2018 -3.29095 2.88479 4.98522 -7395 6 26.6728 30.2949 13.4768 7.17255 0.654769 14.1147 -7396 4 25.7117 30.2905 13.6467 8.22624 -2.44269 3.31295 -7397 4 27.1112 30.3188 14.3546 -11.9073 -0.623098 -17.8849 -7398 6 24.8734 30.8117 10.8292 -29.6944 -3.60301 -2.53615 -7399 4 25.2254 30.0431 10.3884 7.40196 -6.71761 -6.36825 -7400 4 25.5983 31.2424 11.2381 22.0508 11.6497 12.6203 -7401 6 53.1723 24.107 4.51212 -8.50651 -29.3458 16.902 -7402 4 53.5087 24.8189 4.00388 11.9327 21.9784 -14.7749 -7403 4 53.9335 23.6869 4.92936 2.49868 2.30602 2.88115 -7404 6 24.9006 4.49574 23.9943 -15.2803 12.8054 -1.91421 -7405 4 24.3197 5.26112 23.9044 -17.3839 -11.7779 6.16284 -7406 4 25.6928 4.95696 23.7819 42.3091 -2.82475 -3.31223 -7407 6 34.6808 1.64534 41.2582 -1.16689 -16.4189 -19.1193 -7408 4 35.6107 1.42238 41.0689 -7.35569 3.11738 8.02352 -7409 4 34.6894 2.06091 0.199506 5.11707 10.3461 19.9542 -7410 6 13.3318 19.5273 16.3875 10.456 -31.2285 9.008 -7411 4 13.8245 19.0713 15.6714 -4.89067 6.02882 4.66139 -7412 4 13.1633 18.7854 17.0362 1.8233 23.0525 -16.1268 -7413 6 48.6827 0.169575 20.4108 24.7259 -31.926 -14.6767 -7414 4 49.2893 41.6148 19.7702 -18.6338 21.3246 17.3218 -7415 4 48.933 41.6689 21.2514 -6.5025 5.85221 0.333279 -7416 6 43.0578 27.7881 11.5189 -10.6888 1.76469 -10.0665 -7417 4 42.6538 28.0077 10.6554 5.1393 -6.0393 10.108 -7418 4 43.5199 28.5835 11.7935 3.33621 0.984046 2.36511 -7419 6 25.7084 21.3766 35.1933 7.92601 18.71 -2.37973 -7420 4 25.8037 22.0957 34.5091 -5.30878 -22.9017 16.0752 -7421 4 25.4462 20.5484 34.7558 3.58761 11.0813 -0.636196 -7422 6 44.7325 4.60288 27.7529 -5.18995 0.47983 -9.95788 -7423 4 44.2388 4.02478 27.1463 1.34738 -4.40857 1.63455 -7424 4 44.3371 5.47709 27.6067 3.7052 -1.13476 4.16529 -7425 6 41.2786 11.441 34.2043 -0.416747 21.9122 -5.07112 -7426 4 40.7165 11.5703 33.4237 0.0697438 -4.14349 0.395824 -7427 4 41.2047 10.5155 34.4107 -4.51201 -19.8544 2.93408 -7428 6 19.8751 36.6454 2.03332 12.5662 31.6724 6.60432 -7429 4 20.6794 36.321 2.43856 -1.22315 -24.7147 -1.51883 -7430 4 20.0441 37.6041 2.15193 -20.0718 -8.75186 -9.57731 -7431 6 27.484 4.65653 6.35518 1.28922 -40.4385 -58.6648 -7432 4 27.5497 3.77116 6.72735 -1.75384 3.56143 11.9553 -7433 4 27.4257 5.33486 6.97498 -2.79123 31.4549 44.9969 -7434 6 16.8428 30.7659 39.9509 7.31092 -42.6244 -5.47757 -7435 4 16.9464 31.3097 40.7337 2.60533 1.47109 13.0941 -7436 4 17.1496 29.8303 40.1512 -5.48449 28.5555 1.20442 -7437 6 51.1542 15.2049 16.3406 35.1838 19.4064 -24.6303 -7438 4 51.2473 16.0791 15.87 -9.06363 -20.4986 13.944 -7439 4 52.0128 14.747 16.0894 -33.4595 8.32861 13.6861 -7440 6 49.9911 21.2271 35.9695 16.4294 -24.4585 13.2328 -7441 4 49.3547 21.5056 35.3276 -17.8928 6.13619 -17.6667 -7442 4 49.9245 20.2453 36.0087 2.29216 20.3869 -1.95357 -7443 6 34.4275 0.15221 5.68266 -0.837995 23.3079 0.855413 -7444 4 34.2957 0.929489 6.27037 2.93096 -11.6463 -16.4536 -7445 4 34.3488 0.459476 4.74482 0.623699 -7.30698 18.2278 -7446 6 48.316 11.5365 19.8846 -3.65813 -3.14803 11.8504 -7447 4 47.8503 11.3247 20.7373 6.31016 14.4835 -28.1035 -7448 4 47.7834 12.1052 19.2757 1.33379 -13.4076 20.6299 -7449 6 4.19577 39.4409 13.3607 25.3524 9.34899 10.5928 -7450 4 4.92582 39.74 13.9847 -33.0668 -7.48624 -17.3574 -7451 4 3.31127 39.5736 13.758 11.9971 1.78205 4.76714 -7452 6 8.7457 16.1809 8.53298 -1.62633 17.1572 -22.0575 -7453 4 8.74512 16.8853 9.19115 0.0519099 -7.3494 1.25428 -7454 4 8.72812 16.6658 7.66651 -0.023414 -16.7756 16.7144 -7455 6 29.0271 14.2712 26.5342 -13.8591 45.9397 20.1216 -7456 4 29.0757 15.2697 26.7309 6.93185 -43.1811 -12.6551 -7457 4 28.1042 14.0702 26.7795 9.9397 -3.04712 -3.53591 -7458 6 27.3813 14.5204 8.1419 -14.0666 1.8718 0.247246 -7459 4 26.4091 14.3966 8.10069 17.9482 5.30051 2.04476 -7460 4 27.5539 15.4689 8.31094 -4.76419 -14.5771 -1.3831 -7461 6 14.1301 27.2156 32.9232 24.3629 15.6041 -10.7258 -7462 4 14.926 27.3266 33.4685 -8.09546 -2.45296 -2.52419 -7463 4 13.4702 26.8045 33.4616 -14.5983 -10.6772 12.2116 -7464 6 31.6563 35.7792 21.2709 -29.1401 -25.1051 5.88501 -7465 4 32.0219 36.5153 21.7512 6.27263 14.1007 6.62418 -7466 4 30.8825 35.462 21.8184 22.9209 7.6802 -13.887 -7467 6 54.2186 28.7134 16.8958 -10.3287 11.0002 2.01575 -7468 4 53.5002 28.4234 16.309 3.24852 -2.61584 3.16662 -7469 4 53.9524 29.6107 17.1726 0.515277 -7.78004 -0.375364 -7470 6 9.0512 5.27483 17.1492 25.6572 1.38615 -17.9054 -7471 4 9.89534 5.12229 16.6101 -31.8522 3.085 22.1798 -7472 4 8.85255 6.23494 17.0921 1.81156 -15.0607 2.57474 -7473 6 29.6868 9.77258 26.5671 22.9889 -14.8503 10.4327 -7474 4 30.5444 9.2887 26.5838 -17.3341 11.3615 1.53321 -7475 4 29.3655 9.78642 27.4819 2.88877 -1.07091 -0.346791 -7476 6 44.0288 31.1766 32.1743 -14.2068 1.02328 22.4178 -7477 4 43.2475 30.9789 32.739 9.50682 -2.17476 -16.522 -7478 4 44.5788 31.7142 32.7564 8.88854 3.82935 -1.95952 -7479 6 53.49 3.62433 25.1454 11.2777 4.02107 -26.8953 -7480 4 54.1404 4.33507 25.1993 -2.49783 6.11479 15.045 -7481 4 53.6886 3.29227 24.2489 -10.294 -6.80459 12.4065 -7482 6 12.451 22.8746 3.38821 10.4278 8.96452 22.9237 -7483 4 12.7779 22.025 3.15024 17.1772 -24.972 1.67394 -7484 4 11.7815 22.9738 2.74712 -31.3784 16.165 -21.5343 -7485 6 39.42 29.6871 0.722943 17.2287 20.3893 -0.939439 -7486 4 39.938 29.1007 0.168548 -5.00448 -5.71086 -1.61555 -7487 4 38.6697 29.2119 1.03517 -14.5725 -11.7208 3.22357 -7488 6 13.7451 37.8179 23.0399 -3.65878 -32.3471 -6.65898 -7489 4 14.6418 38.0465 23.3627 -20.7195 15.519 -6.09735 -7490 4 13.1315 38.5597 22.9108 15.1185 11.2609 5.5967 -7491 6 33.3417 41.2334 -0.000336223 20.2285 27.8942 26.4667 -7492 4 33.8463 0.176253 41.7571 -17.5829 -26.3423 -4.93882 -7493 4 33.4991 41.0748 0.960438 -12.6248 -4.93214 -20.7453 -7494 6 15.7246 3.51737 6.33987 10.6879 -4.05507 31.4744 -7495 4 14.9251 3.29652 6.83809 -1.96505 1.65417 1.3128 -7496 4 15.4345 3.71468 5.4634 -8.944 6.24557 -22.4591 -7497 6 27.7713 30.7539 5.06912 -9.69485 -19.9648 -11.4393 -7498 4 28.5319 30.6575 5.66481 -7.77203 -4.90526 -3.90413 -7499 4 27.6074 29.8515 4.67882 9.36195 16.9347 11.4385 -7500 6 13.3277 7.57287 23.3467 18.1651 -5.37845 17.9429 -7501 4 14.1986 7.86136 23.0073 -11.0143 -2.49266 1.50668 -7502 4 12.7134 7.55433 22.6278 -8.93981 2.52131 -14.7715 -7503 6 38.3049 37.3174 27.9983 8.70135 -12.5747 15.655 -7504 4 38.3154 37.3922 27.0572 -6.74668 8.75695 -30.2201 -7505 4 39.0324 36.7087 28.1704 1.61648 -2.88985 11.5174 -7506 6 35.8266 12.5392 12.0897 -2.57405 -7.53067 12.8361 -7507 4 35.6491 11.5922 12.0112 2.97069 1.46586 -4.70523 -7508 4 36.2655 12.8127 11.2954 6.10525 2.83369 -11.8718 -7509 6 52.1153 23.0889 41.2774 53.3714 4.98692 -14.9993 -7510 4 52.5505 23.0114 40.3503 -31.9828 -2.74691 35.5054 -7511 4 51.1752 22.9201 41.2974 -16.3051 -5.99839 -13.4785 -7512 6 39.5458 11.6586 16.6081 -4.87816 2.10267 -34.9091 -7513 4 39.8889 10.7596 16.6462 4.61035 -3.54577 11.4771 -7514 4 39.4661 12.017 17.4857 2.58954 -3.33375 20.5696 -7515 6 0.680688 9.01153 7.97148 24.3969 36.1639 -33.0882 -7516 4 54.7452 9.01592 8.14854 -24.8099 -10.5681 8.91807 -7517 4 1.15172 8.32837 8.40327 2.66278 -26.2854 21.5078 -7518 6 42.3319 28.747 39.482 14.4944 54.9029 13.7373 -7519 4 41.6099 28.5069 40.0315 -24.977 -16.9351 14.372 -7520 4 42.5658 28.0062 38.9777 10.1954 -37.5926 -27.6332 -7521 6 38.7351 30.2774 16.2793 4.0737 2.19128 11.2593 -7522 4 38.8758 29.8829 17.1681 -0.562728 7.98522 -10.8415 -7523 4 39.3736 31.0181 16.2214 -9.64538 -12.7452 3.65311 -7524 6 7.59373 18.0328 0.655349 -39.2466 -13.429 1.02247 -7525 4 7.12412 17.545 1.38102 15.2508 10.2608 -15.5396 -7526 4 8.49503 18.0746 0.920891 28.7098 -1.69475 13.4339 -7527 6 33.7283 34.5883 24.1367 2.81913 -0.677006 -1.55035 -7528 4 33.5209 35.3543 23.5868 -0.36085 -2.23271 3.31185 -7529 4 34.0202 34.925 24.9956 3.1898 -0.550642 -1.12415 -7530 6 16.0108 40.0553 39.5926 -11.937 1.54577 -14.812 -7531 4 16.9471 40.1686 39.433 15.7688 -0.191962 4.71606 -7532 4 15.632 40.0274 38.6953 -1.55756 -1.47356 6.94311 -7533 6 4.49381 37.1265 21.8421 33.1234 -31.7004 -39.5319 -7534 4 4.78916 37.7556 22.4729 8.60512 21.3704 21.7375 -7535 4 5.32421 36.8863 21.3047 -36.9575 7.65083 16.8008 -7536 6 39.2568 20.1405 31.3294 -11.3601 -2.01094 -17.3558 -7537 4 39.2441 20.8952 31.9186 1.64276 10.2876 11.6417 -7538 4 38.6708 20.3662 30.5789 5.24327 3.39586 9.04201 -7539 6 28.5615 6.15748 32.0463 -1.77815 -13.6106 -5.56393 -7540 4 29.3688 6.39317 32.5024 4.03477 3.32162 5.90581 -7541 4 28.0645 6.97719 31.936 3.86184 3.53187 3.02469 -7542 6 9.32925 11.326 38.2021 -45.7357 8.82179 -18.9514 -7543 4 8.63026 12.0506 38.2047 26.1946 -20.5574 6.08922 -7544 4 8.95275 10.6938 37.5333 17.8336 11.1262 12.3014 -7545 6 41.6094 10.4714 6.86105 10.1449 -2.02989 30.4141 -7546 4 41.8033 10.1647 7.80154 -6.16714 11.7455 -31.3638 -7547 4 41.7667 11.4361 6.82819 -2.03628 -11.6206 -3.02795 -7548 6 3.11959 28.1093 17.6239 10.7497 -46.175 24.4008 -7549 4 2.68352 28.5892 16.9552 -19.7085 26.1099 -29.6067 -7550 4 3.57016 28.7359 18.1797 1.91623 14.188 4.79643 -7551 6 39.3448 12.237 19.2548 -14.1137 14.4353 18.1644 -7552 4 39.3198 13.2124 19.4672 -0.23776 -25.4214 -5.72266 -7553 4 38.5957 11.8144 19.7397 13.7352 7.639 -10.0067 -7554 6 2.76578 9.12322 31.711 10.2249 -26.7767 20.5709 -7555 4 3.2959 8.42892 32.18 -23.1647 11.967 -1.06293 -7556 4 3.41205 9.47362 31.1162 6.35119 16.2437 -14.7539 -7557 6 47.0978 34.3186 24.1743 26.4285 -20.6373 22.1669 -7558 4 47.9222 34.8155 23.9694 -26.3889 2.76484 -4.38573 -7559 4 46.3048 34.7125 23.8251 -6.69439 19.4391 -11.1209 -7560 6 41.2781 35.6191 9.5379 -9.82526 -0.200667 -5.59214 -7561 4 40.3156 35.6289 9.77314 20.3165 9.2235 -0.933793 -7562 4 41.677 36.5159 9.62264 -17.3348 -12.0484 0.717846 -7563 6 20.4662 31.4486 3.15039 -21.7086 3.64016 -5.07598 -7564 4 21.0332 31.2208 3.90109 -5.23001 0.711793 3.99895 -7565 4 19.5233 31.6154 3.43158 26.7394 -6.53789 -0.258783 -7566 6 33.2215 17.9623 24.8097 -0.453891 -1.34226 7.30289 -7567 4 34.1788 17.9667 25.0617 -18.0356 9.24084 -3.8919 -7568 4 32.8105 18.8566 24.8334 12.2893 -13.6267 3.75162 -7569 6 40.152 39.887 35.7648 -20.6867 7.32712 26.7748 -7570 4 39.5869 39.7633 34.9934 2.3303 1.35559 2.0998 -7571 4 39.5428 40.1203 36.5292 18.9615 -7.74514 -25.9591 -7572 6 4.86846 34.7127 16.4904 2.99496 1.45153 -7.51648 -7573 4 4.94748 35.6438 16.2302 0.473437 -5.16658 -0.520329 -7574 4 5.67201 34.2663 16.1683 2.12015 0.152524 1.06444 -7575 6 19.1332 11.0374 26.5471 0.604362 14.7011 2.3555 -7576 4 19.0986 10.7741 25.6217 -2.73437 -5.06461 -1.05922 -7577 4 19.4813 10.3027 27.0576 -1.53582 -10.5153 -0.687646 -7578 6 54.0201 13.9196 34.7874 -7.69802 -2.07317 -2.05829 -7579 4 53.0764 13.9769 34.9536 -3.33021 -5.1824 4.14914 -7580 4 54.0417 14.262 33.8952 13.8623 5.56658 -9.2157 -7581 6 1.84699 20.6587 5.20972 14.9439 0.361847 -39.2318 -7582 4 1.3018 19.9191 4.88605 -0.816153 4.45331 11.6833 -7583 4 2.38828 20.8916 4.39492 -13.6739 -1.13034 29.3331 -7584 6 22.2428 0.0912174 14.2544 2.10511 -1.36215 24.2926 -7585 4 21.4939 0.626329 14.4934 -11.4394 6.88953 -7.77601 -7586 4 22.6568 41.86 15.1175 2.53583 -3.69112 -10.285 -7587 6 4.95629 7.04242 24.7427 6.31781 -9.23371 -7.19194 -7588 4 4.17782 7.32111 24.2434 0.969413 4.1364 5.47863 -7589 4 5.24611 6.21648 24.3187 1.32276 5.05146 9.71893 -7590 6 41.4805 20.8726 34.9438 -11.2314 22.7349 11.4525 -7591 4 42.1022 20.1554 34.9949 12.4759 -11.6791 0.0999164 -7592 4 41.5325 21.3468 35.8092 3.20944 -13.6901 -15.0483 -7593 6 28.2157 1.74547 31.725 -9.95228 -2.94536 5.02618 -7594 4 27.5723 1.08944 32.0352 4.54694 0.234407 -12.282 -7595 4 28.3302 2.26918 32.5198 6.68924 9.49254 2.75715 -7596 6 16.8899 27.3746 36.9858 -9.49677 -4.03922 3.2671 -7597 4 17.2157 28.1459 36.4964 2.86939 -7.49192 -2.31982 -7598 4 17.0938 26.5386 36.5152 1.89463 15.2676 -1.69393 -7599 6 26.8243 38.069 8.34482 13.7761 41.6132 3.1747 -7600 4 26.4823 38.3279 9.22598 3.84792 -18.6223 -11.4711 -7601 4 26.785 37.1424 8.19579 -7.88027 -37.9853 9.71444 -7602 6 26.6634 33.7911 23.2273 -21.2745 -8.43567 7.74896 -7603 4 27.1019 33.3181 22.5212 7.04537 -0.372104 -6.32159 -7604 4 27.3305 34.169 23.7872 14.5385 6.50935 5.10733 -7605 6 10.2166 27.1183 30.2276 16.2509 -17.1331 -9.46175 -7606 4 10.1765 28.0583 30.3796 2.29392 15.9864 2.71565 -7607 4 10.9387 26.9511 29.5696 -14.5483 8.58048 15.0042 -7608 6 47.87 12.5975 5.02268 -6.13754 10.9902 -1.31963 -7609 4 48.1357 13.4822 5.34438 -4.36861 -17.8106 0.719643 -7610 4 48.2725 11.9144 5.56853 6.38614 1.6905 7.47062 -7611 6 53.3393 24.5639 22.1523 -40.2275 -1.43509 1.91788 -7612 4 53.1884 24.513 23.11 6.12251 -0.709171 0.80005 -7613 4 54.2538 24.6676 21.944 28.1496 2.10984 1.66559 -7614 6 29.4072 10.7569 19.3822 52.4151 15.8336 -9.71081 -7615 4 29.248 9.98119 18.8618 -10.0643 -15.3346 -6.0739 -7616 4 28.6282 10.9567 19.8417 -45.3483 4.87471 22.9978 -7617 6 39.4757 14.9522 19.5461 30.0359 -1.30311 42.0602 -7618 4 40.386 15.231 19.9108 -38.5728 -7.77311 -23.4682 -7619 4 39.3498 15.357 18.6983 1.75067 15.7407 -16.9704 -7620 6 32.8823 15.9838 22.806 -0.988113 9.61369 -4.64335 -7621 4 32.9657 16.5376 23.5815 3.43203 16.8704 5.79609 -7622 4 32.7087 15.1359 23.1895 -5.55033 -22.0541 3.57771 -7623 6 30.5481 1.96835 21.5144 8.4955 -1.31523 7.25762 -7624 4 30.7645 2.06729 22.4547 -1.5525 1.72807 -3.05596 -7625 4 31.3563 1.607 21.1075 -12.3766 3.94884 0.453046 -7626 6 0.972615 11.9937 3.31932 2.75381 16.0475 9.69945 -7627 4 1.12058 12.9582 3.29011 -6.67466 -9.20629 -8.78254 -7628 4 1.16803 11.7633 4.23669 1.49118 -7.35844 2.879 -7629 6 32.1487 30.4035 20.7885 -10.2937 2.79415 -8.64413 -7630 4 32.9584 30.6778 20.3377 1.19491 2.22071 -1.75985 -7631 4 31.4018 30.7106 20.2304 12.8433 -5.61998 7.3235 -7632 6 5.36663 35.5196 9.0005 -13.7636 -10.8617 -1.51226 -7633 4 5.10558 35.6694 8.09522 3.88385 7.21083 -8.97177 -7634 4 4.84313 34.7327 9.21079 3.19207 0.561776 9.20467 -7635 6 49.9075 13.051 32.2032 24.7068 -1.78611 -22.7634 -7636 4 50.5917 12.8604 31.4934 -20.1594 10.2365 23.451 -7637 4 49.3072 12.3042 32.1357 -5.12737 -3.80929 6.93874 -7638 6 4.31321 24.0956 1.58545 -15.4175 -15.0012 -21.2972 -7639 4 3.62325 24.7374 1.73273 -2.73087 12.0747 8.21305 -7640 4 3.96758 23.5799 0.823479 15.3265 9.07188 13.8923 -7641 6 44.1581 38.1227 12.3545 -1.42535 -29.4608 0.820402 -7642 4 43.4877 37.5183 12.7749 7.78878 22.0847 -6.23147 -7643 4 43.9706 39.05 12.5061 -8.83193 8.8938 6.46859 -7644 6 44.688 17.3349 22.7943 52.857 -4.21013 7.29678 -7645 4 45.2391 18.0521 23.242 -20.6522 -19.8992 -14.1432 -7646 4 45.3699 16.6167 22.57 -26.4285 25.231 9.0384 -7647 6 20.3608 11.6914 19.667 7.58964 -15.1508 -20.1027 -7648 4 20.0231 12.466 20.0832 -9.22037 21.7722 17.9466 -7649 4 20.541 12.011 18.7627 0.78957 -9.8802 4.31695 -7650 6 4.45783 15.4051 36.2022 4.17523 -10.6616 -1.13379 -7651 4 5.07913 14.7124 35.8925 -4.22209 9.46347 0.0108161 -7652 4 3.57023 15.0045 36.1544 3.18966 5.51307 1.04981 -7653 6 44.8105 39.5245 30.1712 -12.2097 -12.5983 -29.4865 -7654 4 44.6649 39.2374 29.2388 12.2423 8.81859 19.2473 -7655 4 44.0848 39.0946 30.6384 -0.298867 5.38951 7.86823 -7656 6 30.0635 3.50956 11.3278 16.0802 -2.39158 -40.3094 -7657 4 30.5444 4.30508 11.007 -11.8296 -5.04519 20.5985 -7658 4 30.1379 2.92562 10.5291 -8.6007 1.99314 24.6663 -7659 6 25.6288 24.8657 16.1423 35.3146 -5.68436 -0.158812 -7660 4 26.5897 24.7732 15.9989 -9.69879 -4.30362 -13.2764 -7661 4 25.6615 25.1054 17.0605 -14.6317 7.6504 23.2411 -7662 6 36.8074 29.8609 20.6529 -16.3286 -4.81766 17.6852 -7663 4 35.9316 30.2459 20.3982 14.0867 -8.19012 9.60149 -7664 4 36.7164 29.3161 21.4988 -1.56746 21.2483 -31.978 -7665 6 52.2273 17.0565 38.3075 -18.6216 -30.1938 15.1193 -7666 4 51.4912 16.4635 38.6201 23.7372 14.7716 -7.00173 -7667 4 51.7959 17.5937 37.6524 -0.777677 7.661 -6.77585 -7668 6 3.82637 23.6296 29.8591 26.0466 24.015 14.1033 -7669 4 4.67122 23.3872 29.4436 -4.98409 -4.75234 -2.50433 -7670 4 4.14214 24.3103 30.5173 -20.0237 -17.5461 -14.7603 -7671 6 6.36694 19.9104 41.0994 -7.87156 6.69529 -0.551213 -7672 4 6.75531 19.2216 41.6418 3.91706 -4.8357 7.00798 -7673 4 6.43687 20.7189 41.61 0.371167 5.3541 9.12827 -7674 6 28.9069 38.9219 35.3342 18.1363 5.4885 19.4373 -7675 4 28.4975 38.2544 34.8057 -13.0204 -17.6003 -18.1497 -7676 4 29.7244 38.4883 35.6529 -6.84193 6.3312 -4.3373 -7677 6 1.06391 30.294 34.4744 17.4659 -4.25802 33.126 -7678 4 0.923806 29.8092 33.6831 -4.92213 -16.9626 -31.6436 -7679 4 0.43107 31.0027 34.4841 -13.3738 11.5818 -2.38269 -7680 6 26.4433 22.0338 20.438 10.4135 -19.5508 3.73058 -7681 4 27.3849 22.2767 20.3653 -17.5193 8.20183 -1.91668 -7682 4 25.8117 22.75 20.2981 5.30742 7.62512 -2.77887 -7683 6 3.9439 18.647 22.686 19.6053 -30.212 14.064 -7684 4 4.76982 18.631 23.2404 -22.0254 9.00566 -12.7221 -7685 4 3.71052 19.5535 22.5456 -1.30938 28.7031 -1.82281 -7686 6 6.87955 39.3273 26.9921 -1.67667 -12.9446 -11.9216 -7687 4 7.1836 39.9129 27.6984 -12.429 3.42242 7.34442 -7688 4 5.90054 39.2886 26.9896 13.9064 15.8094 12.8698 -7689 6 43.976 41.7556 26.5281 4.8347 -4.89589 -5.39334 -7690 4 43.9038 0.242071 27.3891 4.48323 5.1383 20.2804 -7691 4 43.1144 41.9148 26.1591 -17.5097 2.26447 -13.804 -7692 6 31.7137 29.57 16.9845 -29.8695 1.84649 5.70955 -7693 4 31.0051 28.8814 16.8861 15.511 13.0746 -1.88966 -7694 4 31.2475 30.3377 17.3963 12.872 -19.7765 -2.8161 -7695 6 46.2467 10.9544 15.5549 14.6537 -15.0388 13.4913 -7696 4 45.2992 10.7621 15.4719 2.35584 -6.3837 2.44855 -7697 4 46.7422 10.1008 15.6673 -18.7057 18.8904 -8.1417 -7698 6 36.5806 15.025 25.8165 21.8026 1.76557 9.13915 -7699 4 37.3648 15.4873 26.2149 -21.7037 -15.0217 -10.3096 -7700 4 36.1201 14.6319 26.5704 -2.31195 -1.95921 2.19148 -7701 6 47.2758 22.6707 6.12549 -20.393 21.5378 -17.5673 -7702 4 46.5536 23.2672 5.80637 16.9751 -15.6011 5.88158 -7703 4 47.0174 22.4855 7.02503 2.56882 -3.04752 8.65489 -7704 6 27.5281 39.6653 17.8063 9.11062 13.5998 -14.667 -7705 4 26.6008 39.6971 17.5421 -9.18871 -3.65478 0.40423 -7706 4 27.5952 39.1072 18.5692 -4.91094 -8.97362 13.813 -7707 6 14.0432 27.9674 36.8911 6.42031 -13.692 3.20322 -7708 4 13.4093 27.2386 36.6831 22.3711 16.0651 -1.21324 -7709 4 14.9745 27.6178 36.9209 -23.5128 3.35359 -2.56993 -7710 6 33.7582 13.0225 13.8549 2.82411 10.3644 -10.1378 -7711 4 34.6192 13.1187 13.3682 -26.1927 -14.0119 11.7219 -7712 4 33.447 12.1034 13.9061 16.5995 3.21583 -3.74575 -7713 6 3.39066 17.4794 1.96807 -11.027 -24.2448 -29.9928 -7714 4 3.01559 16.7425 1.36999 17.4474 35.7284 24.3857 -7715 4 3.43148 18.2603 1.39088 -0.910914 -5.0095 5.82543 -7716 6 27.5636 2.76805 36.4448 23.3016 6.40537 7.49337 -7717 4 28.0874 2.94382 35.6362 -14.0128 -4.70143 5.95918 -7718 4 26.7201 2.39292 36.1778 -1.1877 -0.145823 -5.22631 -7719 6 21.3174 1.20043 18.721 3.60184 -34.5623 26.1973 -7720 4 20.9731 2.06802 18.64 -8.90193 33.3239 -10.7294 -7721 4 20.989 0.903829 19.6038 6.52339 -1.5964 -17.0558 -7722 6 11.8953 16.678 29.2972 -24.0209 -12.1876 15.7906 -7723 4 10.9907 16.5502 28.9196 20.2967 4.53139 4.03679 -7724 4 11.83 16.2797 30.2084 5.50538 14.3948 -24.2902 -7725 6 15.9723 29.4609 29.6333 0.682268 26.1612 18.9471 -7726 4 16.8848 29.3174 29.3467 -1.47573 8.2327 2.84191 -7727 4 15.9822 30.2485 30.2615 3.64459 -27.0302 -18.4378 -7728 6 42.9269 7.03734 4.5197 11.663 -6.03152 6.53833 -7729 4 43.4231 7.50219 3.8104 -1.91258 -11.2042 14.7177 -7730 4 43.564 6.5391 5.10838 -14.9069 13.4822 -19.2581 -7731 6 46.4099 26.3175 18.5001 -14.65 2.77244 -10.2078 -7732 4 46.6739 27.1133 19.0164 -10.4759 -17.1195 -12.5948 -7733 4 45.7242 26.5969 17.8403 16.3643 -1.95791 15.5671 -7734 6 26.8576 31.9381 30.1176 11.4414 -26.9795 -35.8502 -7735 4 27.1259 30.9869 29.8859 -9.79711 36.6724 15.314 -7736 4 26.5998 32.3006 29.2227 5.46388 -10.7605 29.9307 -7737 6 19.4818 37.6192 31.2596 -32.5143 -22.3469 33.0613 -7738 4 19.0962 36.8501 30.8088 8.72557 8.52431 -5.84089 -7739 4 19.0944 37.5229 32.1795 16.9146 13.3756 -22.466 -7740 6 52.3665 32.7318 12.7942 -5.34222 7.33615 -3.08781 -7741 4 51.884 32.8768 11.9489 17.9119 0.95058 7.1847 -7742 4 53.27 33.1068 12.8183 -18.0778 -3.45769 -11.3622 -7743 6 6.73992 9.26339 24.0285 -18.4022 -33.2824 -0.456279 -7744 4 6.43016 9.52976 23.1488 2.39009 0.543925 -1.37305 -7745 4 6.14044 8.50785 24.2751 15.0572 15.2043 -3.93749 -7746 6 39.7373 39.5658 25.499 -11.0807 -5.52867 0.517577 -7747 4 39.7453 38.628 25.2585 2.77876 5.57729 -0.31401 -7748 4 38.826 39.699 25.8216 4.65786 0.889055 -1.26295 -7749 6 24.0734 14.0105 21.1438 13.9648 5.3121 -25.5312 -7750 4 23.6065 13.6215 21.8839 -3.42696 -11.6299 6.48748 -7751 4 24.3304 13.3134 20.491 -9.48085 14.6929 20.6508 -7752 6 5.1987 41.7736 24.8713 10.0047 -19.0707 10.1325 -7753 4 6.05769 0.0475547 25.2635 0.547146 -1.74599 -5.91735 -7754 4 4.86042 0.69526 24.5593 -4.41349 12.4443 -5.8689 -7755 6 42.3687 20.86 21.2777 19.2234 -22.1312 -1.40502 -7756 4 42.3783 20.5581 22.1846 0.624409 -1.73106 8.2154 -7757 4 41.7113 21.532 21.2665 -20.5735 20.428 -5.9858 -7758 6 48.2425 15.3687 33.5924 -0.241089 -2.38933 -5.28694 -7759 4 48.6415 14.7162 33.0072 6.18243 -4.87195 3.86709 -7760 4 47.6596 15.8553 33.0028 -7.11438 7.34599 -0.780278 -7761 6 46.0202 38.2953 16.5865 15.7829 17.4793 7.01852 -7762 4 46.7193 37.7552 17.0318 -13.8218 15.7663 -8.05182 -7763 4 46.1673 39.253 16.8241 -2.73609 -24.364 -6.22008 -7764 6 4.62701 28.4898 21.3631 -35.4199 -38.8764 -1.71187 -7765 4 5.05003 28.7578 22.1614 14.3175 13.903 20.3467 -7766 4 4.23296 27.6059 21.6238 11.0236 23.568 -16.8729 -7767 6 20.5692 15.1618 18.3974 -2.72234 -3.16682 18.7699 -7768 4 20.0205 15.9086 18.1633 -0.374776 9.93651 -8.10169 -7769 4 20.1114 14.8073 19.1799 7.71486 -3.14336 -3.02048 -7770 6 16.2446 13.6415 17.4737 -35.4034 4.06645 -23.9936 -7771 4 16.1835 14.6144 17.5029 6.20848 -12.1 -0.082548 -7772 4 15.5556 13.4035 16.7727 24.4056 2.85778 27.0666 -7773 6 52.5084 30.9566 18.1567 -0.97573 -12.5044 17.346 -7774 4 52.0533 31.4717 17.4985 -6.50351 10.4198 -16.9401 -7775 4 51.7821 30.6074 18.6971 11.4062 2.54252 -4.46582 -7776 6 24.418 1.73203 15.7939 2.07222 -10.1482 7.47229 -7777 4 24.2447 1.14878 16.5739 0.390494 16.7143 -9.44633 -7778 4 24.1366 2.64887 15.952 -0.929678 -6.23215 5.34629 -7779 6 23.8719 5.08832 31.0744 22.7283 -21.9769 -16.2257 -7780 4 23.8146 5.92648 31.5054 -7.3092 22.9653 9.22328 -7781 4 24.8319 4.92382 30.9303 -16.6577 0.531409 1.66203 -7782 6 29.6615 30.9343 0.410524 16.5859 -5.2272 -6.83283 -7783 4 30.4171 30.5602 -0.0763344 -8.98044 0.909776 12.9407 -7784 4 29.1293 31.2514 41.5907 -13.3941 8.54792 -1.14443 -7785 6 32.8591 37.9003 22.5268 -10.9299 -3.56267 -2.34485 -7786 4 33.7082 38.1164 22.1304 5.81458 1.66065 7.83892 -7787 4 32.835 38.1832 23.4516 6.53001 6.08896 0.386172 -7788 6 16.4762 17.3653 33.758 -11.7596 5.685 -6.41316 -7789 4 15.9639 18.0545 33.2621 15.6067 -10.6469 10.7903 -7790 4 17.1589 17.009 33.1621 -6.01342 7.59956 -1.04496 -7791 6 9.22918 13.3839 27.5418 -13.213 -9.30661 16.5651 -7792 4 8.30942 13.5198 27.2923 -4.71042 4.84624 -13.6557 -7793 4 9.0972 13.1179 28.4658 14.0632 -0.809421 3.61995 -7794 6 43.4685 7.73978 17.2176 -8.6426 5.21856 8.44668 -7795 4 43.4054 7.77113 18.1985 3.14312 -1.73226 -22.4674 -7796 4 44.4071 7.82788 17.0033 -0.931382 -0.0897333 1.197 -7797 6 22.3132 24.3412 23.1703 -9.75348 13.1727 -0.0757149 -7798 4 22.7871 23.5122 23.2675 1.8966 -9.89464 -1.11237 -7799 4 21.5045 24.1854 22.6454 4.5924 -1.52242 4.18414 -7800 6 26.0037 32.9236 32.716 -4.33416 -0.788049 -7.61174 -7801 4 26.2455 32.6516 31.8136 -0.0498336 0.850388 -0.133699 -7802 4 25.1949 32.4304 32.9126 -0.360701 -0.787143 2.76329 -7803 6 16.9426 19.041 7.45715 -3.10994 24.472 -2.41526 -7804 4 16.308 19.3093 8.14456 3.13816 -6.91205 -2.30089 -7805 4 17.0114 19.8381 6.87129 1.57938 -24.3813 10.2947 -7806 6 48.1131 14.4569 27.5699 7.08917 8.35207 6.49885 -7807 4 48.0603 15.1245 26.8691 -1.5138 -4.18476 1.16992 -7808 4 48.1537 14.9494 28.4126 -1.96213 -3.76556 -9.73571 -7809 6 52.3834 41.7541 11.1123 -0.447482 12.3 22.2377 -7810 4 52.3153 0.228199 10.2442 -0.817032 7.00513 -16.5207 -7811 4 52.6623 0.571857 11.7011 -4.41087 -5.87968 -8.23494 -7812 6 36.3325 6.93202 12.7048 -8.66608 5.7588 -1.53482 -7813 4 36.3873 7.88419 12.9074 5.41886 -9.49824 0.0534512 -7814 4 37.2464 6.6206 12.6662 3.93968 -0.5832 -0.272047 -7815 6 8.24609 20.3242 16.6676 2.28714 -8.73249 -3.11806 -7816 4 7.99607 19.3797 16.5602 0.915774 9.85224 4.30221 -7817 4 9.21956 20.3717 16.6442 -3.81833 -2.78155 -1.09608 -7818 6 28.8059 40.3215 12.8316 -6.32157 -2.99739 9.80695 -7819 4 29.5356 40.2333 12.2314 15.0973 -2.52646 -11.1155 -7820 4 28.4555 39.4209 12.8947 -4.4969 5.39171 3.74805 -7821 6 18.1648 11.8204 16.9538 6.42365 10.4423 10.6103 -7822 4 17.6537 12.6149 17.1793 -7.21931 -10.1359 -1.31065 -7823 4 19.063 12.1656 16.925 9.05203 -3.86377 -1.18548 -7824 6 30.8803 17.4233 21.4874 -38.9186 -21.5127 -11.6054 -7825 4 30.1793 16.7188 21.4067 15.4039 25.3522 4.50617 -7826 4 31.5864 16.9116 21.8642 20.5617 -1.86838 10.7411 -7827 6 34.8073 19.4112 37.959 10.4013 19.2527 -16.7989 -7828 4 34.9062 20.1671 37.3279 -0.177011 -16.5385 16.965 -7829 4 34.2544 18.768 37.5084 -3.31564 -7.45818 -3.12702 -7830 6 35.8251 16.8879 29.2053 19.9429 8.12055 25.1888 -7831 4 36.604 16.4922 29.6427 -6.21008 5.15879 -2.88988 -7832 4 35.5164 16.1914 28.6524 -12.7517 -21.289 -18.0185 -7833 6 3.03682 32.2806 6.33235 -9.22618 28.6071 10.2197 -7834 4 2.10307 32.1357 6.11945 6.4331 -12.4482 -1.5948 -7835 4 3.56193 31.5065 6.1559 2.8275 -21.5224 -7.32445 -7836 6 26.8 41.6522 10.1614 16.4152 -10.6242 6.62789 -7837 4 27.6763 41.4103 9.75871 -19.2491 6.11251 13.5217 -7838 4 26.9685 0.0827479 11.0562 4.26354 0.263175 -7.76775 -7839 6 52.2755 24.564 24.8743 -17.4742 4.09161 11.4913 -7840 4 51.3068 24.6875 24.9545 12.6777 -6.48001 -7.54331 -7841 4 52.5704 24.9086 25.7267 7.88636 1.59704 3.61539 -7842 6 22.6859 22.6471 33.5865 3.00815 -0.389016 -3.70522 -7843 4 23.2377 23.2516 34.129 -18.2936 -9.34398 -1.8364 -7844 4 21.8798 22.3666 34.0572 9.18357 8.33181 5.74035 -7845 6 10.6559 14.2334 33.0439 8.40108 -6.88321 -2.71679 -7846 4 10.5166 14.9368 32.4181 8.42324 10.9453 -12.1325 -7847 4 9.76709 14.0756 33.3137 -17.8131 -11.8211 11.2552 -7848 6 21.913 10.8504 11.5417 10.0273 5.1408 -10.1307 -7849 4 22.8643 10.6911 11.6864 -4.5907 0.219491 7.97275 -7850 4 21.4519 10.7503 12.3817 3.5408 -3.26695 13.1151 -7851 6 38.3604 6.02409 25.8423 -7.72295 28.2176 13.9057 -7852 4 38.0159 6.28095 26.7202 2.23326 -16.155 -4.56644 -7853 4 38.4362 6.90267 25.4438 5.48615 -7.56939 -11.5178 -7854 6 30.9465 26.6393 38.5732 9.04128 -30.5088 -25.1958 -7855 4 30.9128 26.4505 39.498 -1.67119 3.99535 28.8865 -7856 4 31.0441 25.726 38.2186 -4.36445 16.9712 0.749916 -7857 6 30.1667 14.6301 35.4838 10.1392 5.1159 -4.4805 -7858 4 30.5216 15.3681 34.9096 -25.1579 -14.4294 10.0398 -7859 4 29.1929 14.5877 35.5299 11.6839 11.6021 -8.75286 -7860 6 12.5351 37.2243 16.9695 -17.9994 -5.54058 0.759354 -7861 4 12.9667 37.9067 17.4519 9.84296 27.0859 15.3185 -7862 4 13.2146 36.5653 16.9126 10.1753 -19.489 -6.1469 -7863 6 27.4306 21.5582 37.7184 0.323044 -0.91237 -2.80926 -7864 4 26.8919 21.7087 36.9418 -1.95891 -4.49412 -14.6911 -7865 4 26.9535 22.0297 38.3943 0.198826 4.23191 11.3586 -7866 6 29.6082 18.3788 12.6829 -3.7237 -11.7076 25.6006 -7867 4 29.4829 18.1024 13.618 2.9495 3.49705 -16.1413 -7868 4 28.7034 18.5321 12.3984 -4.77545 3.00323 -3.28229 -7869 6 2.3585 15.6468 0.175999 -8.20612 37.5639 57.3692 -7870 4 1.52386 15.5898 41.6501 -20.1916 -9.73007 -21.8008 -7871 4 3.00191 15.1099 41.6903 28.5072 -35.3577 -30.6151 -7872 6 17.8194 25.7234 4.22068 -18.7286 -4.35761 2.03057 -7873 4 16.8619 25.5897 3.93795 36.6055 5.10926 -2.3659 -7874 4 18.4291 25.8425 3.4621 -13.2431 -0.0346718 7.72723 -7875 6 41.7912 11.1794 20.2704 -4.7703 -4.22644 -3.97484 -7876 4 42.5222 11.2179 19.6258 -6.77094 -1.14571 2.2342 -7877 4 40.9861 11.4636 19.8126 1.73275 2.14556 -1.92771 -7878 6 38.0378 18.3863 24.0278 -3.74133 -10.331 -0.132081 -7879 4 38.4309 19.0888 24.5482 3.22643 8.24914 5.57345 -7880 4 37.9308 18.7305 23.1431 0.767244 4.53126 -6.25669 -7881 6 4.13298 13.9173 33.7521 30.6843 -35.3272 -10.2657 -7882 4 3.2388 13.7394 34.0326 -6.45696 -6.01886 0.999898 -7883 4 4.62487 13.0231 33.6052 -30.6419 39.0128 7.66426 -7884 6 19.1936 19.1847 26.5022 -1.72621 -3.50471 2.07629 -7885 4 19.5259 20.0399 26.2155 5.41694 7.89262 1.74938 -7886 4 18.9505 18.7515 25.6854 -0.500338 -7.01675 -4.74744 -7887 6 22.475 26.1945 25.3345 -21.4458 -23.9003 -3.16659 -7888 4 22.3709 25.4906 24.6814 -7.32491 -4.57374 0.352876 -7889 4 23.3013 26.5414 25.0733 33.537 19.6696 -4.44151 -7890 6 48.8098 32.073 32.5556 -12.1052 4.48194 -0.190297 -7891 4 48.9381 31.1381 32.4233 -5.03309 -16.3747 0.495313 -7892 4 49.6354 32.4434 32.2762 12.9514 12.9364 -2.07298 -7893 6 25.2177 18.014 27.013 4.13139 4.11129 3.02633 -7894 4 24.4991 17.5573 27.49 6.6231 -0.568789 -7.074 -7895 4 25.6482 17.4406 26.3525 -8.92874 -1.57445 7.95973 -7896 6 1.76475 41.5608 24.9549 2.89162 -9.06076 -21.1384 -7897 4 1.88611 40.794 24.3317 -1.07403 19.5272 24.3581 -7898 4 1.30092 0.287142 24.3881 5.67761 -7.93757 11.1942 -7899 6 18.6633 11.7702 10.8608 -14.1102 -15.1967 11.3789 -7900 4 19.5021 11.9001 10.4051 -2.67857 -1.17934 -0.0567829 -7901 4 18.6465 10.841 11.1975 0.382459 20.6246 -9.54243 -7902 6 45.6242 16.5573 4.85031 17.0541 -2.39304 -3.72853 -7903 4 46.5701 16.2411 4.85652 -23.9929 13.0597 -1.64852 -7904 4 45.6057 17.5078 4.58964 5.38323 -15.7737 4.77093 -7905 6 40.6798 36.3894 24.0177 5.99482 15.2006 -18.5281 -7906 4 40.7505 36.8152 23.1136 -3.68852 -16.1642 25.9152 -7907 4 40.7388 35.4259 23.9735 0.360603 0.79119 -4.57544 -7908 6 32.2161 36.322 4.9431 5.19197 18.2152 11.0878 -7909 4 31.5074 36.1415 4.30154 10.9387 -10.0795 -6.57323 -7910 4 33.0257 35.7839 4.88769 -13.0089 -6.05715 -7.93038 -7911 6 1.60369 14.6754 10.8168 -10.3056 7.30247 33.6992 -7912 4 2.33423 15.3134 10.9307 -7.1595 -6.86026 -1.25923 -7913 4 1.1476 14.6845 11.711 13.0511 -0.847163 -26.6328 -7914 6 35.0153 14.2871 28.0739 18.7596 2.69464 30.5166 -7915 4 34.8734 14.0618 29.0187 14.279 3.49385 -12.2543 -7916 4 34.1456 14.1907 27.7398 -26.4062 -1.19123 -20.5956 -7917 6 54.7157 6.11907 21.8609 -12.1949 -7.16094 1.89291 -7918 4 53.7846 6.03827 22.1577 10.7478 1.95047 -3.13077 -7919 4 0.0370646 6.90146 22.3147 2.89466 7.98076 3.79048 -7920 6 31.7642 16.9274 27.3665 -7.54316 -5.52924 6.90942 -7921 4 30.8348 17.1206 27.2023 -9.34166 0.83246 -0.0222557 -7922 4 32.1928 17.2544 26.5838 13.9998 7.82105 -16.2222 -7923 6 14.4504 28.0052 11.1087 -4.71237 -14.6735 4.6077 -7924 4 14.1081 28.8557 11.3451 -9.65694 14.7183 8.34222 -7925 4 14.826 28.1745 10.2406 5.25389 -7.26775 -5.19981 -7926 6 35.6627 19.4906 18.309 1.38743 3.66357 1.00844 -7927 4 36.0608 19.4502 19.1905 -8.3289 1.62604 -1.04031 -7928 4 34.971 18.8114 18.299 7.41978 2.58016 -0.85803 -7929 6 0.908295 12.7232 15.4509 -10.2874 -45.1283 5.64528 -7930 4 0.635795 11.7526 15.3361 10.0925 35.0181 2.47128 -7931 4 1.39513 12.719 16.2997 -3.76012 1.73199 -7.91518 -7932 6 52.7239 14.8052 20.9911 -10.1838 -50.8962 13.8805 -7933 4 52.1355 13.9729 20.9263 20.4043 37.1153 -0.0771148 -7934 4 52.3678 15.481 20.4204 -9.75671 2.85516 -9.21068 -7935 6 7.50014 6.78453 13.6112 45.6118 -3.77462 -0.237279 -7936 4 7.66407 7.72531 13.7166 -11.095 5.64184 -2.33744 -7937 4 8.44113 6.46934 13.5548 -33.3093 -4.56257 -1.46213 -7938 6 12.8693 29.1327 30.951 -35.1999 43.7452 -37.9705 -7939 4 12.911 28.5157 30.2274 6.73286 -14.9776 0.757022 -7940 4 13.2432 28.8129 31.7306 26.8069 -31.1286 39.1504 -7941 6 8.91269 29.9946 35.6682 4.82638 -20.5676 13.9142 -7942 4 9.08199 29.9869 36.6487 -3.4848 12.9743 -23.6701 -7943 4 8.85763 30.8835 35.2999 2.4913 8.97671 5.8399 -7944 6 29.2501 7.21193 5.56384 -35.3124 23.3999 -5.45769 -7945 4 29.8929 6.567 5.7677 24.3163 -25.3556 4.38867 -7946 4 28.4878 7.00912 6.14468 16.2636 8.35776 -7.44031 -7947 6 25.8882 9.2493 3.85609 -10.1418 -10.3657 2.14015 -7948 4 26.6938 8.77544 3.58522 -5.62061 -1.52714 -0.987441 -7949 4 25.143 8.71761 3.5088 14.4855 4.13341 2.07026 -7950 6 46.1828 19.5303 23.8452 27.5142 -8.79556 18.2338 -7951 4 47.0303 19.3932 24.4147 -29.6641 11.3761 -34.952 -7952 4 46.4302 19.9015 22.9687 10.0609 -5.49214 13.8961 -7953 6 18.6 35.3226 28.7813 33.9262 -21.2248 5.29661 -7954 4 18.5078 36.1255 28.2543 2.15121 5.76995 -5.3877 -7955 4 19.5645 35.0126 28.755 -37.0827 17.274 -2.06568 -7956 6 28.0068 22.625 32.1882 17.1638 -9.71048 -11.652 -7957 4 28.1161 23.0799 31.3381 -0.933036 0.686599 6.01892 -7958 4 27.1717 22.9224 32.5558 0.319614 0.839726 2.26602 -7959 6 25.9992 18.4251 22.6716 -8.51512 -6.6596 14.3523 -7960 4 26.8098 18.8237 22.3895 20.3106 6.57833 -11.9809 -7961 4 25.8253 18.8771 23.5162 -1.041 -7.57666 -6.79729 -7962 6 31.1689 23.0872 29.1831 -2.26749 -18.4759 6.78914 -7963 4 31.118 22.1592 28.8841 -5.05583 5.59361 3.05947 -7964 4 31.7418 23.5345 28.5581 5.1573 7.79625 -4.49352 -7965 6 36.6391 4.9259 0.480345 37.9344 10.2065 -26.5572 -7966 4 36.638 5.82198 0.886244 0.658013 -14.6584 -5.92388 -7967 4 37.39 4.95173 41.699 -35.1456 1.42767 30.4358 -7968 6 36.484 21.0145 10.0529 -6.00883 6.48187 8.17175 -7969 4 36.4042 20.1763 9.58301 3.63574 2.58382 -3.15576 -7970 4 35.8773 20.9259 10.8015 2.14778 4.06152 -0.936887 -7971 6 50.5993 25.1947 18.3919 -28.2028 12.9956 8.35013 -7972 4 49.869 24.7394 17.9262 9.19638 1.46827 3.55355 -7973 4 51.4482 24.8993 18.0848 11.0575 -8.08323 -5.33222 -7974 6 50.1824 39.6576 12.4356 -22.7811 -7.9912 15.1349 -7975 4 49.7705 38.7879 12.6194 4.75387 11.043 -2.88475 -7976 4 51.0686 39.4751 12.1603 15.8621 -1.53988 -6.37666 -7977 6 30.5412 12.4178 4.80566 -15.3128 -2.78075 25.3711 -7978 4 30.0752 11.5776 5.01806 10.6669 11.6172 -5.90727 -7979 4 31.021 12.2424 4.01172 11.531 -8.83371 -18.4272 -7980 6 28.9525 15.4713 21.8679 -2.36978 -36.4192 26.6063 -7981 4 29.1677 14.6271 22.3934 -7.66269 33.2693 -19.6276 -7982 4 28.1632 15.8063 22.3348 7.54721 -2.84859 -11.2752 -7983 6 14.0684 9.5583 16.997 2.7235 -6.59901 -0.744295 -7984 4 14.8185 8.94582 17.0717 -0.0957791 5.7783 -3.11218 -7985 4 14.4323 10.4488 16.9992 1.00571 2.57913 -1.39277 -7986 6 4.48903 30.1743 11.858 18.777 -10.7052 13.2768 -7987 4 4.86699 29.7697 12.6847 -17.3276 7.96894 -17.1216 -7988 4 3.53137 30.2861 11.9207 -0.113543 -0.314347 4.01346 -7989 6 40.8874 8.0652 23.6541 0.993335 -18.0149 -24.6412 -7990 4 41.0014 8.23968 22.6934 -0.45004 7.6784 15.1082 -7991 4 40.7726 7.0925 23.6399 1.20374 9.92563 8.58777 -7992 6 53.7462 35.0557 16.7061 9.98011 -4.48961 -22.2856 -7993 4 53.4827 35.8182 17.2307 0.000554802 6.10184 -1.96461 -7994 4 54.0786 35.3449 15.8213 -7.68991 -0.599931 23.4559 -7995 6 53.7073 10.1889 20.3718 -10.7517 16.2467 -19.4493 -7996 4 53.8408 10.0262 19.4272 8.41512 -10.415 5.03553 -7997 4 53.1338 10.9644 20.2967 0.731263 1.06205 11.7435 -7998 6 4.58979 27.075 7.78807 17.6653 -15.6715 -1.75621 -7999 4 5.19096 26.32 7.80399 16.3727 7.79792 -3.24405 -8000 4 3.78382 26.6199 7.94519 -28.415 1.42755 3.38346 -8001 6 50.5066 22.5306 22.1436 -1.2339 18.6921 5.41009 -8002 4 50.2802 23.3104 22.6632 -2.8343 -11.09 7.6214 -8003 4 50.7991 22.9414 21.3369 4.56213 -7.53044 -15.8119 -8004 6 7.04346 27.196 21.628 9.41144 -9.96736 11.8657 -8005 4 6.8407 26.6883 22.4668 -8.25713 16.2835 -27.3312 -8006 4 6.26031 27.4748 21.116 4.26862 -9.43237 15.0117 -8007 6 23.8265 35.0499 16.5937 18.3012 9.13896 26.4348 -8008 4 24.7235 34.8381 16.9269 -14.9485 7.62278 -2.13189 -8009 4 23.7604 34.5968 15.7714 -3.77201 -11.7597 -22.7393 -8010 6 5.98953 23.8983 3.91761 -44.4181 -14.5448 -1.98234 -8011 4 5.398 23.9519 3.1318 15.794 0.401012 8.45254 -8012 4 5.35617 23.6012 4.61938 19.6174 4.72778 -5.04958 -8013 6 38.7401 25.0729 19.1247 8.8169 4.91643 10.7802 -8014 4 38.7862 24.2921 18.5681 -1.99613 -8.272 -9.94687 -8015 4 39.0639 24.8191 20.0061 -2.94522 4.87881 -4.09917 -8016 6 12.9717 18.2893 10.6182 7.92512 -8.05782 -7.58833 -8017 4 12.0999 18.3162 10.2013 -2.76008 2.25331 1.21984 -8018 4 12.8722 18.6085 11.5165 -3.68712 5.29275 10.5515 -8019 6 38.0382 41.2423 21.0873 4.88219 -19.6272 -0.152698 -8020 4 37.2014 40.7765 21.2484 2.63704 8.02432 -2.02816 -8021 4 37.8835 0.198079 20.7163 -11.2369 15.8096 -5.69312 -8022 6 6.98214 22.8682 17.8394 -5.75247 -17.9204 -1.57462 -8023 4 7.61723 23.542 17.6412 15.6839 20.0065 -5.16874 -8024 4 7.3587 22.0484 17.4826 -2.13646 0.815835 3.23256 -8025 6 24.1186 19.368 12.3177 21.0449 6.23804 -24.2445 -8026 4 23.9242 19.844 13.1293 -4.19124 -3.15082 3.8784 -8027 4 23.743 18.4928 12.3308 -10.9397 -14.908 7.07664 -8028 6 44.2213 28.4415 4.8153 2.12167 -7.44997 -5.8313 -8029 4 44.3009 28.0649 3.91739 -1.37383 9.18016 5.99771 -8030 4 44.2294 29.4128 4.74855 1.01191 -3.53144 -7.03239 -8031 6 23.3167 8.29314 21.4338 -0.329791 14.7993 14.6131 -8032 4 22.995 9.23581 21.5362 7.25813 -26.2111 -7.67418 -8033 4 23.1349 8.01865 20.5229 -2.36131 4.58949 1.23489 -8034 6 14.3464 2.19127 18.5365 1.00479 -5.05512 -1.33996 -8035 4 14.3534 1.26337 18.7781 -10.0191 -8.45544 9.17935 -8036 4 15.2531 2.29149 18.2562 13.6881 11.5937 -7.27189 -8037 6 28.0536 31.92 34.134 3.57463 -14.0429 -1.6048 -8038 4 28.4517 32.4188 34.8607 -2.66641 5.35559 -0.0232853 -8039 4 27.3246 32.4577 33.7701 8.655 -3.68096 2.2403 -8040 6 53.3502 24.7032 18.2649 -24.2711 -41.2818 -9.83264 -8041 4 53.5194 24.6019 17.3193 6.96991 8.47211 -0.102973 -8042 4 53.68 25.5059 18.6169 17.7955 37.5084 3.34479 -8043 6 36.8031 28.4187 22.9511 -10.1554 -0.61119 21.2214 -8044 4 36.5106 28.9054 23.7358 4.15696 8.73481 -5.19311 -8045 4 36.1845 27.6911 23.0035 -2.36033 -17.8474 -9.79811 -8046 6 21.8885 30.5877 27.4793 -3.11585 8.28062 7.57241 -8047 4 22.2621 31.0993 28.2061 -3.96796 1.5816 4.48491 -8048 4 22.5937 30.5949 26.8475 10.2249 -8.24374 -18.6607 -8049 6 10.2833 3.28406 27.2289 -24.5304 -2.91212 14.6365 -8050 4 10.0443 2.76427 28.0065 14.6588 -5.9106 -2.57837 -8051 4 9.44832 3.75002 27.1066 2.80489 10.142 -13.305 -8052 6 37.7147 24.9939 29.6988 5.24245 -12.5023 -10.1121 -8053 4 38.3581 24.5533 29.0689 -23.3017 1.4918 23.5498 -8054 4 37.1779 24.3214 30.1874 12.7329 5.56421 -12.5271 -8055 6 9.13611 24.4367 14.4784 20.7258 8.96054 28.4908 -8056 4 9.04651 24.998 13.735 -5.03994 20.1658 -22.0876 -8057 4 8.726 23.6299 14.2398 -14.2121 -32.2206 -7.12291 -8058 6 52.7755 31.4643 7.39569 14.5412 -1.52098 0.484013 -8059 4 52.3413 32.1584 6.88884 0.00633314 4.2069 -4.47258 -8060 4 52.0605 30.9716 7.79316 -9.34275 -9.05133 5.36325 -8061 6 21.3287 5.44475 36.4975 17.176 -11.9485 -14.2877 -8062 4 20.7483 5.50715 37.2619 4.90115 -8.53405 7.77147 -8063 4 21.912 4.64524 36.5597 -18.1029 20.6035 4.94996 -8064 6 25.1768 37.2214 4.32574 4.31983 -25.8241 -7.35849 -8065 4 25.4326 36.64 3.57657 -1.88178 18.0132 5.09494 -8066 4 24.8685 36.5657 4.9694 -1.32139 10.7309 7.78615 -8067 6 33.9928 17.4475 18.2473 -28.4515 -0.0793518 28.5349 -8068 4 34.2921 17.0113 19.1053 -15.0281 13.9289 -20.2703 -8069 4 33.1064 17.9171 18.4165 33.1367 -21.5966 1.81969 -8070 6 37.9532 37.4932 25.2939 -37.7872 -15.4269 -20.4394 -8071 4 36.979 37.7096 25.1406 34.3292 -3.43428 9.43604 -8072 4 38.1084 36.7677 24.6487 1.47089 11.2608 10.0337 -8073 6 5.08061 4.87523 15.8431 -4.86231 -7.56388 -2.23136 -8074 4 5.78156 4.1744 15.8759 -9.54967 26.0091 2.46095 -8075 4 5.43258 5.75 16.0822 6.78608 -13.538 3.56789 -8076 6 14.1628 7.20449 7.78038 25.2379 -5.46067 -13.6381 -8077 4 13.5115 7.54153 8.36471 -22.6877 11.2017 23.85 -8078 4 13.6914 6.99143 6.96374 5.13235 0.836748 0.117842 -8079 6 24.9714 10.8522 38.0874 21.7543 24.8019 24.8971 -8080 4 25.3733 11.7327 37.9223 -2.75098 -14.513 10.3213 -8081 4 24.5811 10.6456 37.27 -22.0988 -18.3607 -37.1034 -8082 6 35.6792 7.98105 22.8098 -5.63995 -0.874411 -1.68631 -8083 4 36.3111 8.66137 23.0699 5.30437 2.23481 0.770305 -8084 4 35.3824 8.20038 21.9134 0.62108 2.61089 2.3422 -8085 6 24.7967 29.145 22.4166 8.97915 1.26062 2.6062 -8086 4 24.9285 28.4017 23.0307 -7.24415 3.31799 -2.87627 -8087 4 23.8684 29.1691 22.1667 -6.93063 -5.53381 0.128782 -8088 6 38.5003 31.6402 38.4666 0.118802 17.9484 -3.06973 -8089 4 38.5639 32.3894 37.8454 -0.598215 -11.959 -0.514206 -8090 4 38.3632 32.08 39.3134 -2.43734 -3.45212 12.1107 -8091 6 7.2246 33.2558 15.4144 3.93224 14.6297 14.7993 -8092 4 8.10558 33.3578 15.8508 -19.4169 -6.69939 -13.0108 -8093 4 7.30076 32.5035 14.7978 2.24681 10.3389 8.67702 -8094 6 43.3411 23.605 1.45378 1.24542 -6.52262 6.11498 -8095 4 43.1714 24.3501 0.858367 5.1295 -5.17404 3.37123 -8096 4 44.2208 23.7695 1.84296 -12.8059 2.13297 -8.4534 -8097 6 3.53981 32.9157 14.8686 -7.67856 -8.73615 6.98201 -8098 4 3.60397 33.2061 13.9566 0.668747 6.43783 -7.96574 -8099 4 3.81902 33.649 15.4236 5.03764 7.23473 -0.501009 -8100 6 25.308 21.7722 8.24708 3.37146 -12.406 14.7751 -8101 4 26.0573 21.1741 8.36562 1.41198 8.84323 -6.65363 -8102 4 24.826 21.6647 9.09095 -1.64121 7.89428 -12.8382 -8103 6 43.814 15.3562 17.763 -19.8802 -3.64728 -7.58039 -8104 4 43.4756 15.1225 16.8733 5.20247 0.973102 4.81929 -8105 4 44.7686 15.2775 17.7045 7.07231 -2.77487 -5.74422 -8106 6 15.7867 16.2594 16.6597 40.7179 11.0003 30.8626 -8107 4 16.4245 16.8568 16.2414 -0.344326 0.180624 1.74019 -8108 4 15.1074 16.2177 16.037 -41.8412 -2.72902 -33.087 -8109 6 31.9018 12.864 11.5221 -0.527288 11.9796 -2.61342 -8110 4 32.4715 13.19 12.2739 -15.261 0.218931 -18.2329 -8111 4 31.4408 13.5947 11.0331 13.5047 -10.6099 18.0399 -8112 6 18.2179 5.3463 10.1762 9.71532 5.2148 -18.3501 -8113 4 17.8204 5.66693 9.33813 -2.6575 -7.74782 15.1878 -8114 4 17.5556 5.18411 10.851 -9.29453 0.73034 -3.17809 -8115 6 23.0812 39.0781 10.9303 2.37609 8.25457 -4.90642 -8116 4 24.0025 38.8104 10.892 -1.10831 -0.594451 2.83356 -8117 4 23.078 39.9337 10.4697 -7.78026 -4.85412 5.47405 -8118 6 46.8678 33.747 8.76655 -5.11485 44.7451 24.4631 -8119 4 46.406 34.5339 8.40734 -0.304999 -21.98 -10.152 -8120 4 47.1603 34.1422 9.62028 2.09293 -20.2864 -11.5212 -8121 6 31.2447 39.9321 20.2226 -0.330123 -0.585472 -4.98228 -8122 4 30.8504 39.3151 19.5884 6.05804 4.05585 3.92388 -8123 4 32.2053 39.9316 20.0453 -4.95864 -1.44581 -1.12159 -8124 6 15.9016 33.0949 19.7876 25.1907 -5.52815 -22.1207 -8125 4 16.0748 33.7133 19.0349 -1.92202 -14.988 11.1016 -8126 4 16.5267 32.3265 19.6592 -15.8695 19.8556 5.2806 -8127 6 32.5654 39.9188 2.66304 17.6014 -10.2623 -15.3377 -8128 4 33.3417 39.59 3.14903 -11.9816 5.68487 0.865723 -8129 4 31.9971 40.348 3.29791 -5.42947 4.08066 9.69521 -8130 6 50.71 12.2088 3.91621 6.45352 -28.1924 -19.9843 -8131 4 51.4315 12.4725 3.33505 0.00989865 5.72461 1.55844 -8132 4 50.5782 12.8645 4.57223 -0.528152 29.464 22.8196 -8133 6 44.6954 2.75762 12.1022 0.941183 0.541095 5.21442 -8134 4 45.0772 1.91827 11.8337 7.97486 -4.13832 -5.1586 -8135 4 44.7961 2.76556 13.0748 -3.12194 1.26681 -13.8655 -8136 6 11.5119 11.9446 31.6555 0.0165034 5.87533 16.9496 -8137 4 11.2786 12.7291 32.193 1.1093 -4.42098 -1.85793 -8138 4 11.5615 11.2089 32.2952 3.49417 6.36211 -10.0029 -8139 6 4.75553 10.0442 10.5026 -0.613356 7.28818 -1.41717 -8140 4 5.04922 10.2458 11.3982 -0.190174 3.033 -2.19553 -8141 4 4.45357 10.8768 10.0827 4.22944 -8.29703 6.91569 -8142 6 17.1004 25.0221 20.585 20.8628 27.7333 -27.8469 -8143 4 16.2314 24.7196 20.7848 -24.892 -11.5638 6.73224 -8144 4 16.9745 25.5771 19.7683 4.93088 -15.3222 19.1034 -8145 6 48.1032 4.75801 14.8026 37.7024 -16.8658 7.41777 -8146 4 47.1817 4.923 14.9438 -21.3904 13.2232 -6.86149 -8147 4 48.4894 5.33532 14.1187 -17.354 1.23192 4.40994 -8148 6 18.8584 3.1094 3.41532 -17.9645 -5.092 -5.76247 -8149 4 18.4858 2.24853 3.65522 2.22195 0.198645 3.24183 -8150 4 19.7914 2.99202 3.55078 21.8001 -2.9136 1.99579 -8151 6 35.4214 26.4496 29.0479 -25.0869 -13.2406 8.30382 -8152 4 35.4596 27.2122 28.4766 3.66886 10.9927 -9.48044 -8153 4 36.2884 26.0622 29.0901 17.6032 -4.12101 -3.28535 -8154 6 32.3918 31.2203 12.8386 46.3164 14.9485 -1.56764 -8155 4 31.5927 31.2548 13.3118 -34.7781 -0.694705 18.2501 -8156 4 32.2274 30.836 11.9945 -8.46486 -12.2685 -25.2096 -8157 6 32.9972 28.3347 37.5978 -19.2694 -14.478 20.0019 -8158 4 32.1604 27.8545 37.87 25.9433 12.8245 -4.2723 -8159 4 33.4478 28.5699 38.4425 -10.0504 -3.89776 -17.7975 -8160 6 45.4943 24.785 10.3174 -24.9891 51.3938 13.5053 -8161 4 44.9436 25.3819 9.72852 18.6998 -28.2383 15.0369 -8162 4 45.6946 23.9769 9.88803 3.95472 -26.3164 -24.236 -8163 6 14.7646 31.7016 3.17106 -12.494 -4.77828 16.8956 -8164 4 14.1278 32.382 2.84257 8.55448 -13.727 9.9815 -8165 4 14.4774 31.2925 4.03575 0.781246 20.1514 -26.73 -8166 6 31.932 7.70259 4.29822 28.2629 -13.9597 32.9447 -8167 4 31.5142 6.8338 4.23667 -1.26054 0.464616 -4.26218 -8168 4 31.5893 8.26695 3.64018 -18.9284 22.0156 -31.588 -8169 6 42.5661 17.3076 32.2072 4.58091 20.9841 -12.8778 -8170 4 41.6153 17.2751 32.1225 -13.9289 -9.63208 0.974916 -8171 4 42.7549 18.1312 31.7017 7.23855 -15.1499 9.29454 -8172 6 13.801 23.1802 23.5544 20.5107 -9.18639 9.43365 -8173 4 13.5559 23.799 24.2431 -7.02941 8.57916 4.58982 -8174 4 14.6139 22.757 23.9348 -15.8084 7.21572 -12.2969 -8175 6 10.7224 7.09218 3.96878 16.2046 -14.1912 -58.7694 -8176 4 10.4615 7.01435 4.86228 -13.7845 -9.22242 34.898 -8177 4 10.4899 6.25858 3.45399 4.94204 24.1379 24.5516 -8178 6 28.7975 8.66057 17.8838 -26.4281 5.00156 -27.4828 -8179 4 29.5466 8.31163 17.3909 5.91048 -3.96826 -5.96201 -8180 4 28.1517 8.96764 17.1731 20.0585 -9.38402 22.2692 -8181 6 19.4445 29.3512 26.6402 -27.7559 12.8002 37.2849 -8182 4 18.9931 29.7086 27.4672 16.1765 -10.1498 -30.4371 -8183 4 20.3292 29.7071 26.6996 8.86807 3.45557 2.67965 -8184 6 40.676 40.9989 14.5783 -1.81287 -10.2023 17.4849 -8185 4 40.8703 41.6798 13.9303 10.8761 5.87921 -5.34291 -8186 4 41.4788 40.6754 15.0317 -0.103076 9.61372 -9.63617 -8187 6 46.2568 14.0853 31.7234 10.6503 -1.46249 4.93376 -8188 4 46.4506 13.1375 31.7184 -3.79774 3.42444 -0.601084 -8189 4 45.5065 14.2191 31.1522 -8.96365 0.976246 -7.34606 -8190 6 36.7103 36.3065 8.39844 -19.1971 -27.2559 -17.1971 -8191 4 36.3822 37.2167 8.51449 20.2374 -9.10083 14.9839 -8192 4 37.462 36.0245 8.9597 -8.83948 23.9771 2.75809 -8193 6 30.7983 32.4219 38.0908 -28.9564 1.76229 18.7871 -8194 4 31.3387 31.9445 37.476 23.2205 -2.83162 -11.1976 -8195 4 31.2894 33.1287 38.5298 9.85106 -3.61838 -6.87003 -8196 6 47.9 8.84746 10.1809 13.9026 13.2481 4.99334 -8197 4 47.2314 9.07534 9.54683 -14.9306 19.0332 -8.73943 -8198 4 48.008 7.93273 10.003 10.2061 -26.7512 4.08493 -8199 6 24.4282 17.0027 30.9766 -8.14946 0.47403 -13.61 -8200 4 23.7021 16.9118 30.3187 14.132 0.581257 9.28124 -8201 4 24.0019 17.1514 31.8341 1.66288 -1.35228 -5.87998 -8202 6 40.5039 5.09263 4.48513 -8.56504 -6.5373 -32.2613 -8203 4 41.2755 5.64065 4.37578 16.2932 9.35997 9.97847 -8204 4 40.1843 5.0523 3.55179 -2.89742 -7.45623 19.6864 -8205 6 52.5794 28.086 6.91602 -27.2154 -20.1235 6.97783 -8206 4 52.4353 28.6007 6.11552 3.94928 -0.112987 0.705634 -8207 4 51.6969 27.6552 7.08025 27.1089 14.7333 -4.60736 -8208 6 36.0629 32.381 23.6142 9.17579 -16.9148 -2.4755 -8209 4 36.5407 32.2813 22.7776 -1.15674 3.38979 7.41153 -8210 4 35.7113 33.2654 23.6252 -9.15386 11.2493 0.0331211 -8211 6 23.6552 31.8756 22.7565 -25.0136 1.00336 21.6204 -8212 4 23.73 32.5959 22.1297 15.1034 -2.64982 -11.1407 -8213 4 24.3343 31.2055 22.6866 12.2933 -0.39941 -10.0267 -8214 6 0.736598 24.4641 41.7072 -6.94393 1.55048 -19.4095 -8215 4 1.23654 24.8288 40.9522 -3.95743 -2.80997 9.51773 -8216 4 54.8325 24.2702 41.3637 13.4109 4.08216 3.5339 -8217 6 15.9721 8.97822 19.8125 19.0517 -22.613 16.6544 -8218 4 15.5497 8.29105 19.3091 -4.28185 -9.24838 -10.3339 -8219 4 15.6128 9.78815 19.5092 -16.7051 35.4763 -13.493 -8220 6 33.1656 12.5735 20.0353 32.8597 -32.3881 -24.7893 -8221 4 32.9817 11.6196 19.8453 -6.04217 28.6875 8.28399 -8222 4 34.1172 12.6638 19.7368 -32.1809 10.6792 11.3696 -8223 6 7.04894 24.9401 26.3957 -12.3425 -2.00741 -5.21086 -8224 4 6.75821 24.2907 27.0478 8.01299 -1.99342 6.24335 -8225 4 7.89161 25.3154 26.6505 10.7219 -3.29246 12.7441 -8226 6 44.479 22.5508 36.9163 -6.8399 -5.44184 13.3083 -8227 4 43.5214 22.4098 37.071 12.5044 3.3732 -3.51472 -8228 4 44.595 22.7899 36.0028 -4.86816 3.42784 -13.6235 -8229 6 39.2745 23.7032 25.1197 -32.3737 -81.7274 9.17932 -8230 4 39.5886 24.5492 24.9992 24.471 68.8814 -13.2187 -8231 4 38.7456 23.4691 24.3377 5.22396 6.33701 6.85867 -8232 6 20.3646 2.19602 36.9892 -4.85825 6.83938 3.69158 -8233 4 20.3067 1.45038 37.5971 1.4243 -8.23943 -2.36696 -8234 4 20.3942 1.88275 36.0861 3.42557 -6.35335 -2.19064 -8235 6 22.8664 19.5513 3.67104 -13.2265 5.28042 31.2857 -8236 4 22.7633 19.8561 4.6286 7.01101 -9.22167 -32.7463 -8237 4 23.7764 19.7315 3.39612 4.00916 2.85623 5.02623 -8238 6 31.705 12.5768 34.6039 18.8969 7.7197 42.0834 -8239 4 31.1026 13.3107 34.9476 21.2302 -23.3848 -5.30166 -8240 4 32.3569 12.3026 35.3493 -33.8624 17.1964 -33.567 -8241 6 12.9851 10.2105 25.0956 -25.1193 26.0078 -38.429 -8242 4 13.6149 10.0452 25.7619 22.39 -15.9831 32.7066 -8243 4 12.4963 9.40655 24.9468 1.34194 -14.9569 1.62555 -8244 6 27.2621 0.584423 13.2176 -28.6404 -16.2485 2.71576 -8245 4 27.7069 41.6292 13.1518 2.13728 8.59646 -2.51953 -8246 4 26.2847 0.395264 13.1771 23.0038 6.72582 -0.601928 -8247 6 5.66006 24.9398 13.9833 -7.43295 9.91556 10.5591 -8248 4 4.70147 24.9177 13.9802 -4.26929 -7.73667 -8.07402 -8249 4 5.82197 25.381 14.8221 8.41297 -1.15026 -0.763214 -8250 6 22.9908 17.9523 0.521723 7.02411 -25.4698 12.909 -8251 4 22.4592 18.6506 0.142784 -9.22706 3.46645 -2.83539 -8252 4 22.3527 17.3052 0.930771 13.2695 22.3169 -13.3733 -8253 6 33.0935 25.4243 5.46557 -9.38497 -10.8046 -8.60877 -8254 4 33.4966 26.2756 5.44764 14.9521 17.8538 5.01915 -8255 4 32.9941 25.2035 4.5344 -2.6207 -6.96629 2.5324 -8256 6 8.53079 7.95552 17.4804 7.64086 6.41223 -26.4035 -8257 4 9.4001 8.35547 17.2638 -9.73917 -4.33322 7.64386 -8258 4 8.4487 7.94255 18.4286 4.30191 2.70426 16.6029 -8259 6 26.8371 0.685906 2.89773 -0.256761 31.01 4.86999 -8260 4 26.7806 0.433187 3.83156 0.637082 -2.67537 2.60738 -8261 4 26.6279 1.66343 2.89109 6.9325 -26.481 -2.08778 -8262 6 50.0417 34.7142 15.6334 -23.0288 8.72534 -30.9996 -8263 4 50.5531 35.2159 14.9759 6.02412 -4.51102 12.1494 -8264 4 49.1615 34.6714 15.1751 14.0914 -5.62478 19.352 -8265 6 46.2791 4.99946 11.1196 9.7179 12.4772 -7.72995 -8266 4 45.7827 4.25534 11.4529 -10.6417 -11.5364 6.26713 -8267 4 46.9456 4.6214 10.5389 1.00953 -4.68959 -1.2994 -8268 6 33.7936 38.6123 35.3918 15.2762 25.882 47.4359 -8269 4 34.0305 39.0866 36.2411 -6.18084 -28.1229 -24.2145 -8270 4 33.6134 39.3784 34.8506 -5.42867 -1.33428 -20.4371 -8271 6 30.8282 25.8371 41.2172 -7.09757 -19.9215 -22.3179 -8272 4 31.1427 24.9253 41.375 1.19635 8.28989 4.89631 -8273 4 31.1138 26.3841 0.0263053 10.2845 10.2166 22.0109 -8274 6 50.2275 0.982033 24.4751 51.8832 -7.79127 14.7425 -8275 4 49.5671 0.561213 23.9746 -37.5145 -10.5742 -20.1648 -8276 4 51.0349 0.46072 24.2534 -17.6876 18.8276 11.0022 -8277 6 31.2908 0.710797 19.047 -2.09434 13.573 -1.22083 -8278 4 30.4487 0.672221 18.611 -14.5784 9.11804 -11.7691 -8279 4 31.2841 41.7946 19.4765 8.98672 -35.4229 20.9418 -8280 6 39.0741 29.5515 19.1276 -25.3595 -21.9961 15.137 -8281 4 38.1807 29.4949 19.565 25.109 7.94863 -12.7917 -8282 4 39.4837 28.6866 19.3452 2.49072 15.8212 -6.56848 -8283 6 21.6546 17.5955 25.8962 -6.78298 15.7545 0.118362 -8284 4 22.0482 18.4938 26.0891 -15.3421 -24.4294 -5.96834 -8285 4 20.8112 17.7106 25.4012 18.8301 2.25602 6.45745 -8286 6 35.0761 28.7988 27.4227 3.11164 -5.22767 30.3338 -8287 4 35.4099 29.4705 28.0422 -1.31539 -7.25274 0.820077 -8288 4 35.176 29.229 26.5925 2.58985 10.308 -31.8228 -8289 6 30.7102 25.4463 11.6589 -5.09223 14.513 32.8165 -8290 4 30.6059 25.8179 12.6014 3.72506 -14.6402 -39.0718 -8291 4 30.6061 26.1982 11.055 2.14208 -0.820709 7.44645 -8292 6 7.34821 15.124 12.3469 -7.98455 -28.7648 8.02815 -8293 4 6.65824 14.4547 12.1585 7.38491 7.52419 4.72727 -8294 4 7.19665 15.7511 11.658 -2.78105 24.4343 -15.0907 -8295 6 16.8417 26.815 7.05419 -24.774 6.28148 -21.5195 -8296 4 17.6138 26.5995 7.5418 30.7131 -10.23 16.3776 -8297 4 17.1302 26.9688 6.14022 -2.93816 -3.28182 4.8763 -8298 6 29.5112 33.0571 30.9901 -17.2684 21.8413 -16.809 -8299 4 28.6007 32.8494 30.6893 8.91061 -10.9491 6.08618 -8300 4 29.8939 32.355 31.5124 -6.62171 -19.0922 5.25725 -8301 6 14.1054 2.12143 30.9174 -7.90077 -11.4283 37.211 -8302 4 14.0041 2.00138 31.9209 0.0297695 4.78336 -39.0496 -8303 4 13.7376 1.30679 30.5176 6.48361 9.45743 4.44265 -8304 6 15.6593 22.2688 2.88796 -26.3773 12.8308 -8.6958 -8305 4 16.4059 21.7286 3.01985 35.1738 -16.1657 6.55343 -8306 4 15.0005 21.6175 2.62854 -10.183 2.33344 0.69621 -8307 6 23.7324 29.1178 40.9691 12.375 28.71 1.88761 -8308 4 23.2563 30.0016 40.9795 15.1309 -27.3218 0.73938 -8309 4 24.7153 29.2815 40.9372 -24.8849 -3.40565 0.339466 -8310 6 38.1289 14.1609 13.7163 11.3988 23.3452 4.961 -8311 4 37.6355 13.3641 13.8052 -15.0683 -25.2976 3.04519 -8312 4 38.877 13.9408 13.1592 7.07353 -0.711776 -7.39216 -8313 6 35.2564 26.5047 15.5196 1.21661 4.3606 12.6683 -8314 4 34.5556 26.4436 14.8616 -0.145442 -0.409522 -0.299569 -8315 4 34.9009 27.0522 16.256 4.1263 -8.75979 -17.8666 -8316 6 19.0944 34.7315 16.477 3.93496 0.874554 38.8769 -8317 4 19.5342 35.6013 16.5498 -2.87948 -9.96323 -9.99674 -8318 4 19.0181 34.4301 15.5899 3.71142 3.01681 -30.4069 -8319 6 18.1805 29.7449 35.7046 18.8444 17.1873 -3.97052 -8320 4 18.2235 30.6593 35.335 -4.4784 -20.2666 13.1463 -8321 4 19.056 29.5886 36.1261 -9.76671 1.23141 -6.47371 -8322 6 54.1188 22.2659 24.9096 4.78421 -24.6774 -19.3149 -8323 4 53.6441 21.8104 24.1769 10.121 5.11789 9.9801 -8324 4 53.5075 22.9378 25.1661 -14.3198 20.1313 5.7187 -8325 6 30.3323 10.3375 34.0061 7.35563 0.641124 -2.21855 -8326 4 29.5734 10.4043 34.5817 -14.4555 0.0376959 9.72957 -8327 4 30.8213 11.1653 34.1487 -3.17747 -4.67635 -0.590304 -8328 6 38.3211 33.8974 18.5888 -1.32754 -0.89807 -0.720993 -8329 4 38.9926 33.271 18.8539 2.22312 -19.1913 3.89796 -8330 4 38.8713 34.6655 18.5317 3.84957 24.8056 -1.31283 -8331 6 22.4809 14.1697 34.431 -22.1622 -5.27184 -37.8541 -8332 4 22.5433 13.5186 33.673 0.822047 20.8222 24.5167 -8333 4 23.1773 14.0067 35.0533 16.0768 -5.18569 10.3575 -8334 6 38.0141 0.622036 2.34694 9.03481 -5.1652 10.3599 -8335 4 37.7113 1.09641 3.1189 -18.3016 16.1314 2.00329 -8336 4 38.7028 0.120019 2.79986 6.1006 -11.8827 -16.4842 -8337 6 38.8847 41.1446 10.3004 16.8495 57.0142 -12.497 -8338 4 38.6453 0.212884 10.3117 6.47193 -33.8599 -1.337 -8339 4 38.2374 40.7573 10.8541 -26.8649 -17.5582 22.9746 -8340 6 53.4109 21.9211 38.9712 27.3607 0.0645619 -10.5759 -8341 4 53.0384 21.9801 38.0859 -10.7304 2.2749 -0.0111998 -8342 4 54.3668 22.0571 38.7395 -19.1981 -5.88632 12.9741 -8343 6 39.9872 12.7205 36.288 -8.06793 35.3321 20.4333 -8344 4 39.087 12.3834 36.3725 1.18883 -9.13664 -3.11406 -8345 4 40.4905 12.1818 35.7009 7.36107 -20.124 -19.0601 -8346 6 48.4463 17.2389 40.5967 -24.7278 4.81563 12.4078 -8347 4 47.5665 17.6971 40.4852 25.7833 -12.0744 1.257 -8348 4 48.3987 16.886 41.5134 6.10343 4.05346 -12.6042 -8349 6 32.0413 9.35688 40.0251 1.84943 -9.41379 10.5137 -8350 4 32.8011 9.3156 39.4233 -4.71533 -3.42986 0.347912 -8351 4 31.8082 8.43016 40.2864 3.98001 20.4877 -6.20043 -8352 6 31.7351 22.4909 6.36481 -11.9835 4.517 5.86255 -8353 4 31.4453 21.6589 6.79738 2.31245 15.2673 -2.59345 -8354 4 31.3521 23.2372 6.88711 4.39127 -22.2776 -7.77946 -8355 6 51.0252 2.58567 21.5888 12.0252 -3.79771 4.1956 -8356 4 51.3852 1.69652 21.8042 -1.91984 13.1306 -1.09782 -8357 4 51.7712 3.19849 21.4753 -6.25067 -9.48202 2.92476 -8358 6 13.6387 22.0486 12.1519 25.289 13.6281 9.24284 -8359 4 14.4553 22.4795 12.4841 -9.12946 -7.35477 -7.44936 -8360 4 12.9422 22.6971 12.3091 -5.69931 -0.254566 -0.690626 -8361 6 23.6098 24.0343 14.6404 -2.85842 21.3712 -30.1324 -8362 4 24.3054 24.4792 15.1401 1.72137 -5.65962 3.08819 -8363 4 23.5196 24.6041 13.8393 -4.42688 -17.9982 21.1692 -8364 6 9.32217 4.85318 31.2328 11.4746 -4.61869 -4.10735 -8365 4 8.43042 4.86168 30.8848 -9.06213 4.49291 -0.279243 -8366 4 9.25495 5.26013 32.106 -3.85952 -1.36 2.0258 -8367 6 16.6786 26.3118 18.041 -30.5179 5.83101 -14.1852 -8368 4 15.8205 26.6594 17.6987 9.23568 -14.6779 7.38956 -8369 4 17.2149 27.0871 17.9121 20.6972 11.6613 1.32787 -8370 6 5.1068 13.5155 11.5503 -9.62018 18.629 -29.2057 -8371 4 4.37741 13.3629 12.1623 -7.62379 -0.222526 0.540006 -8372 4 4.70689 13.979 10.7366 10.5209 -18.4088 37.9064 -8373 6 29.6181 23.6359 8.06142 -1.81854 7.21422 -1.70755 -8374 4 29.1888 23.4521 8.90141 0.206013 -3.23773 -0.0922606 -8375 4 29.4815 24.5976 7.98987 7.61073 -10.2969 -5.72522 -8376 6 0.801466 7.54671 27.8401 6.5354 -3.49578 -14.7683 -8377 4 0.895859 7.27352 28.7573 1.78004 -0.979843 7.25552 -8378 4 1.54585 8.15528 27.6648 -11.1939 -10.5496 5.25649 -8379 6 15.4336 9.77253 0.489553 0.922542 4.3707 -1.35473 -8380 4 16.0351 9.34865 41.7726 4.14277 -6.55565 2.56274 -8381 4 15.4857 9.31476 1.34042 4.74784 -1.15717 -0.337147 -8382 6 18.8008 0.0730809 34.105 -10.3773 -6.96418 -21.8764 -8383 4 18.5081 41.5423 33.2731 5.22569 12.9238 15.5106 -8384 4 18.5071 0.998566 34.0742 -2.68781 1.40869 -5.2752 -8385 6 18.7326 30.7673 29.1559 48.9948 -22.8293 28.8452 -8386 4 19.5421 30.7479 29.7792 -35.6741 -9.01286 -31.0748 -8387 4 18.496 31.6741 29.187 -17.0068 24.787 -0.45657 -8388 6 48.459 16.4997 36.139 1.45519 10.5028 1.01521 -8389 4 47.6111 16.9857 36.2164 10.4415 -5.87096 -2.55811 -8390 4 48.4968 16.1176 35.2432 -2.18798 4.21486 5.30298 -8391 6 43.8007 0.467658 29.2569 28.3678 -13.8677 -3.77703 -8392 4 42.8971 0.305725 29.4937 -25.3214 -1.14832 5.94808 -8393 4 44.2622 41.5592 29.5347 -3.4854 12.8866 -0.12306 -8394 6 16.7282 13.8764 21.3804 -5.85841 5.25102 8.86173 -8395 4 16.2274 14.7005 21.5266 6.94274 -6.60805 -7.01164 -8396 4 16.607 13.4327 22.2267 1.29648 -4.09529 1.45702 -8397 6 17.3848 13.434 26.2514 27.8708 0.579352 -19.8612 -8398 4 18.2073 13.6243 25.7048 -28.5107 -7.2193 21.7409 -8399 4 17.5944 12.6077 26.718 -2.1357 3.12496 0.608863 -8400 6 48.1647 10.2208 23.7049 7.80266 -18.7522 13.388 -8401 4 47.9825 10.5204 24.6118 -3.05612 1.76991 -8.97221 -8402 4 48.0139 10.9468 23.1026 -1.19683 7.34816 1.26356 -8403 6 28.2773 17.9142 17.8758 3.72989 18.9709 -15.182 -8404 4 29.0682 18.432 17.6259 -4.1904 -8.84834 4.2635 -8405 4 28.5441 17.0749 18.25 8.7895 -11.8779 5.35139 -8406 6 54.0848 38.1774 23.6862 8.79068 2.20397 4.23058 -8407 4 0.0366427 38.003 23.4974 -14.1536 0.885634 -1.20583 -8408 4 53.5245 37.5494 23.203 6.54807 -0.952262 -0.611804 -8409 6 8.48984 18.3998 11.4055 -13.462 -3.57414 27.789 -8410 4 7.65602 18.6961 11.043 -9.38292 3.75479 -0.915161 -8411 4 9.09748 18.5243 10.712 30.3826 3.02886 -30.4498 -8412 6 45.9441 12.8818 11.0222 -16.4049 1.91652 -6.40765 -8413 4 46.711 12.6299 10.4835 -7.54952 -0.564906 -6.57768 -8414 4 45.1235 12.7466 10.4771 21.7466 0.735613 7.10643 -8415 6 16.2215 8.79448 14.033 27.9098 -14.9816 6.01142 -8416 4 15.5522 9.3752 13.7952 -53.829 20.9905 -11.5495 -8417 4 16.9359 9.40542 13.9326 31.9466 3.3348 3.59486 -8418 6 42.7223 13.3863 21.3918 29.8224 16.7773 6.64199 -8419 4 41.9142 12.8874 21.2836 -9.67718 -3.29752 -8.9243 -8420 4 42.6271 14.312 21.0975 -16.0363 -11.184 0.152454 -8421 6 20.9977 40.4228 16.4707 19.2311 -21.9074 5.84064 -8422 4 20.7341 40.0536 17.3362 -0.495629 5.04161 -8.05599 -8423 4 21.8212 39.937 16.2081 -24.2166 11.8961 5.45251 -8424 6 45.6397 11.4296 32.9439 38.4109 -29.1814 -9.99274 -8425 4 46.3321 10.7493 33.2028 -28.4056 24.9384 -5.22126 -8426 4 45.113 11.6624 33.7013 -7.79747 1.97566 18.4384 -8427 6 26.9602 8.8599 24.2968 13.5915 2.79356 4.8338 -8428 4 27.3951 9.75608 24.2837 -6.20264 -27.5971 5.81865 -8429 4 27.4821 8.2415 24.8764 -5.62896 20.549 -11.158 -8430 6 18.9707 2.44141 29.3655 -2.01209 17.0873 0.653095 -8431 4 18.2519 2.38593 30.0124 -1.45633 -1.83702 1.76482 -8432 4 19.0982 3.39915 29.1871 -0.208097 -9.69202 4.76181 -8433 6 8.2396 29.1642 19.724 -7.67611 -9.48635 17.3168 -8434 4 8.16332 28.9052 20.6672 2.00381 4.74558 -18.2193 -8435 4 7.79264 28.4685 19.2154 1.97612 2.42161 3.19163 -8436 6 9.03293 34.3085 18.6392 -6.8245 -3.51508 -5.57673 -8437 4 8.73043 34.3576 19.5508 2.61936 3.47829 -5.40237 -8438 4 9.19173 35.2194 18.3614 3.83285 -0.179546 -0.301582 -8439 6 10.1806 11.9309 11.2378 5.33181 -8.21116 5.18339 -8440 4 10.4199 12.8404 10.9987 -8.38943 -3.43734 -3.26379 -8441 4 9.2213 11.8063 11.1618 4.16708 15.3888 -2.40164 -8442 6 35.7388 21.6853 36.1571 -21.2187 21.2566 3.59668 -8443 4 35.0074 22.3505 36.1843 15.9506 -16.0405 0.715421 -8444 4 36.3839 21.978 36.8321 -7.05156 -5.2756 -8.86951 -8445 6 17.0774 12.5078 36.39 -5.14261 15.8003 12.7424 -8446 4 17.3404 12.7479 37.2961 -4.35419 -1.09545 -7.6232 -8447 4 17.4977 11.6659 36.234 4.71638 -15.3379 -7.50181 -8448 6 37.1607 13.034 34.2837 0.889917 6.85814 -56.1323 -8449 4 36.6144 12.2451 34.135 3.16712 2.80772 8.73621 -8450 4 37.2953 13.1592 35.1962 -1.91867 -3.10361 40.6259 -8451 6 38.9747 29.5563 13.2253 1.18838 24.1885 -12.4362 -8452 4 38.8174 28.6959 12.8484 -2.87796 -16.626 0.178868 -8453 4 38.7606 29.548 14.1582 -0.666122 -3.30753 9.89159 -8454 6 0.17037 29.343 29.4884 -1.26324 3.91124 -27.2421 -8455 4 0.785297 28.6867 29.1327 1.78511 -2.78426 6.40223 -8456 4 54.9717 29.8735 28.6813 -2.47422 -4.8209 18.3172 -8457 6 15.9286 0.264913 12.7638 2.77369 8.97324 -0.606717 -8458 4 15.3998 0.564835 11.9867 -4.35739 -9.72902 15.1241 -8459 4 15.3918 41.7399 13.4663 -4.26125 7.58409 -15.055 -8460 6 3.98508 11.9472 8.79546 -10.0423 -23.9471 10.8905 -8461 4 4.30821 11.7435 7.92681 6.40121 -7.70989 -16.6116 -8462 4 3.96465 12.8834 8.77069 -2.75643 37.1798 9.03734 -8463 6 24.0517 23.6768 19.9772 9.9875 -0.396554 0.578582 -8464 4 23.5025 22.9354 19.7663 -8.47693 -16.0962 -5.40355 -8465 4 23.4442 24.2751 20.4024 2.14545 13.6845 6.88162 -8466 6 4.48152 2.30986 23.9923 -27.0109 23.4084 27.373 -8467 4 4.59263 2.40669 23.0716 9.73085 -3.6317 -36.525 -8468 4 3.6479 2.81506 24.1139 10.3345 -10.6947 10.8816 -8469 6 33.0856 27.6588 33.8383 -8.68317 -6.77689 0.893276 -8470 4 33.3543 28.5605 33.6822 -2.66039 14.7626 -6.22211 -8471 4 33.7694 27.2718 34.3804 4.93538 -5.90298 8.33006 -8472 6 11.4012 21.7076 6.08442 -20.9181 -7.28975 6.20623 -8473 4 12.3452 21.6439 6.06884 23.6791 -0.506282 -5.12853 -8474 4 11.1369 22.1078 5.25059 3.06155 -0.534748 -3.52863 -8475 6 37.2275 13.5312 23.6107 -13.7454 14.8127 9.96245 -8476 4 37.2011 14.0176 24.4689 -4.04457 -8.03454 -15.7104 -8477 4 38.0738 13.1109 23.5305 19.2281 -7.80113 -1.86698 -8478 6 5.00929 21.0475 33.3676 1.03993 27.0325 -33.9401 -8479 4 4.24931 21.2691 32.771 13.0002 -8.94008 10.7478 -8480 4 4.70945 20.492 34.0664 -10.4226 -16.4153 18.9759 -8481 6 18.2024 37.5737 26.9347 11.0126 -1.54132 -8.69207 -8482 4 17.8515 38.4557 27.1129 2.92195 -1.85995 -3.39903 -8483 4 18.9058 37.6892 26.2602 -8.80934 -3.84756 9.96821 -8484 6 19.7475 16.1502 4.67922 -0.59461 -5.69737 6.80756 -8485 4 18.938 15.9829 5.17999 -0.503733 6.42822 -3.53139 -8486 4 20.452 15.899 5.29485 1.51569 2.54074 -3.7554 -8487 6 54.0588 32.502 15.5791 2.11509 -30.3723 -27.0265 -8488 4 54.9193 32.2734 15.944 -2.03587 2.87368 2.60187 -8489 4 53.7148 33.1889 16.1175 -9.21817 24.1266 16.9863 -8490 6 31.1319 3.81908 36.7331 -8.52453 -12.3767 5.98224 -8491 4 31.0251 4.01663 37.6709 2.24281 6.85123 1.97341 -8492 4 30.7371 2.93942 36.6325 4.48759 4.53933 -4.77061 -8493 6 11.8397 14.3559 5.95013 17.712 13.5011 32.6048 -8494 4 11.8882 13.4483 5.64785 3.21485 -4.29204 1.16864 -8495 4 12.4103 14.428 6.79608 -23.3682 -9.2254 -38.5841 -8496 6 30.4732 33.6903 6.46877 -20.5926 30.9984 10.0988 -8497 4 30.0823 33.146 7.15741 -0.571027 -8.82817 5.88036 -8498 4 31.0368 33.1406 5.95739 18.3645 -25.6031 -16.3825 -8499 6 12.7874 0.539502 21.6719 -8.5062 -5.44338 -19.1545 -8500 4 12.0427 0.939271 21.1459 16.6961 -1.79193 22.1421 -8501 4 12.8959 0.982969 22.5241 -5.23507 7.86641 1.50036 -8502 6 52.7588 7.2218 26.198 16.8025 28.3515 6.33153 -8503 4 53.4065 7.96379 26.3423 -21.978 -17.2249 -4.05545 -8504 4 53.0631 6.80021 25.3976 -2.37526 -6.61619 -6.13258 -8505 6 39.7335 40.8867 3.73325 7.25622 8.93714 -16.4459 -8506 4 39.3445 40.0379 3.8542 -7.03998 -23.1188 -2.87281 -8507 4 39.6833 41.2661 4.59764 3.93702 15.0893 17.324 -8508 6 20.121 31.9222 21.9838 -6.71526 -6.20654 6.86321 -8509 4 19.4522 31.9772 22.708 13.7594 -4.46219 -12.9776 -8510 4 20.3423 32.8279 21.7497 1.41177 8.86705 -0.575134 -8511 6 12.8675 35.0031 4.45346 44.828 -17.7313 4.60062 -8512 4 12.2237 35.6716 4.40701 -39.658 29.9319 -2.18346 -8513 4 13.7076 35.4677 4.24983 -7.53722 -6.26381 -0.0905995 -8514 6 24.0625 33.6591 24.8433 7.47563 8.71661 -6.22666 -8515 4 23.7256 32.9086 24.3593 -5.011 -9.84395 -6.229 -8516 4 24.8651 33.8891 24.3525 -1.08488 0.504411 0.449776 -8517 6 40.1566 40.8925 22.745 3.65995 -18.1772 23.084 -8518 4 39.459 41.1173 22.1514 -10.4135 8.7075 -19.9273 -8519 4 39.655 40.5713 23.5068 11.7186 -0.819555 2.88668 -8520 6 15.5608 2.83174 38.4548 -17.961 4.93292 18.3513 -8521 4 14.8017 3.44348 38.6509 23.1729 -8.01231 -13.692 -8522 4 16.317 3.27039 38.0376 1.48109 9.53369 -0.90723 -8523 6 41.0116 9.17543 16.9495 15.4695 -4.08523 -13.4682 -8524 4 41.9148 8.77619 16.8957 -14.8555 5.86712 4.74383 -8525 4 40.5932 8.80873 17.73 -3.00249 -3.47282 8.63794 -8526 6 43.1871 41.3934 9.57744 -8.69666 -18.4537 3.1119 -8527 4 42.3844 40.9156 9.26306 10.8189 9.37287 1.53096 -8528 4 43.2581 0.273962 9.04681 -5.03874 9.79533 -5.6553 -8529 6 24.9044 37.9223 30.7828 -39.5154 -3.84946 22.9815 -8530 4 23.9949 37.8093 31.2426 42.0603 4.56965 -20.1335 -8531 4 24.7148 38.3736 29.9542 -2.24489 2.04808 -5.58176 -8532 6 2.22015 5.33054 16.4399 10.309 -8.52293 4.98471 -8533 4 1.84892 4.56193 16.8809 -9.36945 -1.25887 4.31387 -8534 4 3.13742 5.05729 16.2666 0.349453 6.20437 -4.74718 -8535 6 1.39717 14.946 19.1428 25.1228 15.6369 3.14315 -8536 4 0.624759 14.5201 18.7755 -11.3456 -6.79531 3.66607 -8537 4 1.29195 14.9418 20.1112 -7.64559 -2.97115 -5.19376 -8538 6 34.323 26.551 23.7054 -6.89575 15.1076 -7.90432 -8539 4 33.5377 26.6273 23.1515 0.482254 10.7241 -2.26295 -8540 4 34.2298 25.6735 24.0419 5.3831 -21.6418 13.1607 -8541 6 41.9187 21.8289 37.5387 -12.5221 18.6557 -0.654717 -8542 4 42.0641 21.2774 38.3263 -4.73604 7.9145 -4.0056 -8543 4 41.3184 22.5612 37.831 11.9642 -17.2916 1.51119 -8544 6 39.4187 37.6728 12.6286 4.8532 5.57593 -2.65087 -8545 4 38.7905 38.0203 13.2933 13.4683 3.10916 -9.30227 -8546 4 40.0129 38.4033 12.3216 -17.7433 -13.1833 12.1033 -8547 6 30.24 35.8848 2.88572 49.7685 -5.59713 18.4489 -8548 4 29.7974 35.0543 2.80033 -9.93294 -19.906 -6.06696 -8549 4 29.6668 36.5692 2.63166 -32.6151 32.1739 -11.9765 -8550 6 50.3574 12.2906 11.0327 -10.5999 -17.0186 -10.0309 -8551 4 50.5337 13.0768 11.5186 9.60091 28.0994 7.49192 -8552 4 50.105 11.6994 11.7365 -4.43527 -18.2768 5.14926 -8553 6 38.4177 1.51331 34.6454 7.78381 -17.0522 33.0946 -8554 4 38.2699 2.04814 33.8899 -7.54861 16.9144 -29.9652 -8555 4 38.0471 0.642488 34.4678 -6.5188 -5.83242 -9.72252 -8556 6 23.4539 32.2409 29.2188 -19.2438 22.9381 45.5983 -8557 4 24.0079 32.8299 28.7229 8.54827 0.527122 -15.0299 -8558 4 23.2413 32.797 30.0413 4.80705 -31.5817 -31.7916 -8559 6 36.5701 38.8746 8.90535 32.3223 -9.33237 29.2552 -8560 4 35.9325 39.4424 8.49935 -20.4423 23.0824 -8.61697 -8561 4 36.7801 39.1579 9.82993 -12.7327 0.605838 -19.3651 -8562 6 35.8737 15.8498 32.4386 8.92141 19.9053 -4.5399 -8563 4 36.1418 15.4504 33.2665 1.19933 -3.86396 7.25653 -8564 4 36.5179 16.5897 32.2945 -14.9335 -15.4114 1.1633 -8565 6 22.2892 21.8291 41.5841 -16.2626 10.7882 17.5339 -8566 4 22.1223 22.8053 41.6744 16.5914 -23.4811 -7.73209 -8567 4 23.1242 21.6534 41.1409 10.4107 9.35007 -4.50107 -8568 6 24.3606 38.6964 37.0146 17.4204 12.5043 -4.63866 -8569 4 25.2779 39.064 36.9978 -17.1771 -5.52971 -1.04157 -8570 4 24.4186 37.9719 37.6407 -4.78215 -9.12154 5.30794 -8571 6 45.8441 22.068 16.038 0.340293 -0.250982 -17.8101 -8572 4 46.1771 22.3609 15.1533 -8.50833 -8.1377 19.1007 -8573 4 45.4344 21.1785 15.9468 10.2139 13.0315 -4.03882 -8574 6 34.0918 26.1359 39.6112 38.0511 -8.91464 13.1738 -8575 4 33.1848 26.2338 39.3827 -25.4265 4.60567 1.8853 -8576 4 34.221 26.2032 40.5833 -12.0295 -1.62025 -11.2558 -8577 6 7.22533 36.1661 23.281 -59.3132 -5.14125 -34.652 -8578 4 7.26364 37.0581 22.9295 6.20379 9.34593 -2.3157 -8579 4 7.97006 36.0735 23.8015 59.451 -4.11437 40.0555 -8580 6 29.1637 40.7448 9.14206 -2.51826 7.72751 -13.9009 -8581 4 29.0444 40.3656 8.22324 15.9504 -2.90487 33.8878 -8582 4 29.7314 40.248 9.77766 -4.36215 -9.31282 -20.9127 -8583 6 29.3678 11.2357 1.30083 -35.1077 14.24 19.1284 -8584 4 28.4669 11.4731 0.940057 29.2946 -5.02339 11.2991 -8585 4 29.318 11.4379 2.27092 4.83193 -7.95866 -28.0539 -8586 6 30.9732 3.71267 14.0776 15.2348 -46.8383 -31.5788 -8587 4 31.4582 2.88428 14.3733 -12.5046 34.6753 7.46482 -8588 4 30.8397 3.49874 13.1133 -3.67459 15.4991 23.3176 -8589 6 29.7056 15.2804 38.2794 -11.9618 14.5562 -33.6413 -8590 4 30.2702 15.1354 39.0168 20.1567 -4.59268 23.419 -8591 4 30.0841 16.0123 37.7308 -6.59039 -15.0688 15.6005 -8592 6 36.6264 0.310111 29.1514 -5.04796 -7.83703 -2.09784 -8593 4 37.4271 0.819379 29.3706 -8.93441 4.46737 -4.0897 -8594 4 35.9914 0.856083 28.6484 15.2391 -5.29618 7.37908 -8595 6 47.6417 0.116275 23.248 13.5287 8.94531 -12.2883 -8596 4 47.0119 0.433387 23.8864 -15.3927 3.59754 12.8324 -8597 4 47.4641 41.0946 23.1357 -2.49679 -12.2922 2.24912 -8598 6 7.90637 37.1762 29.9388 8.54368 22.8184 26.8453 -8599 4 7.85301 37.2098 30.9449 3.45275 -3.37357 -41.2712 -8600 4 8.44496 37.9737 29.6897 -17.0006 -23.7003 10.0801 -8601 6 38.9296 24.2329 12.6383 15.5219 -16.6974 -22.776 -8602 4 37.9787 24.1601 12.7323 -9.9748 0.376678 1.49713 -8603 4 39.1449 23.5705 11.9215 -5.67631 22.059 20.3409 -8604 6 21.3179 26.2613 36.7933 11.7928 19.07 -1.51604 -8605 4 20.8397 25.6962 36.2015 -9.60619 -6.53459 -13.3894 -8606 4 21.5182 25.6957 37.5187 2.0605 -10.1459 21.1123 -8607 6 28.2262 23.3351 24.9913 6.08955 -0.748437 0.460504 -8608 4 28.2308 24.0016 25.6964 4.22655 -6.81745 -1.24962 -8609 4 29.0479 22.8075 25.0363 -13.73 7.51762 2.95505 -8610 6 38.3897 39.5713 14.5774 34.0997 -9.77678 18.0089 -8611 4 38.4779 38.8655 15.2987 -6.58584 29.8461 -29.0755 -8612 4 39.3026 40.0121 14.5422 -41.1029 -19.3921 -1.23505 -8613 6 26.0587 6.01626 38.1331 -7.56489 -16.2073 9.45163 -8614 4 26.364 6.92283 38.0032 14.5247 -0.467326 2.92393 -8615 4 26.7573 5.38712 38.4414 -3.391 26.9876 -7.34507 -8616 6 52.1178 17.2513 22.5128 -10.8492 5.54118 7.42996 -8617 4 52.8997 17.6733 22.1718 9.92427 15.7211 -4.0445 -8618 4 52.2219 16.3395 22.2718 -2.102 -18.0313 -4.16051 -8619 6 39.531 30.2011 31.4754 1.32431 5.33104 20.3977 -8620 4 40.1389 30.6029 32.1578 -26.1612 -12.9519 -10.6425 -8621 4 38.6407 29.9778 31.8528 28.462 12.4065 1.81878 -8622 6 19.6595 6.91666 12.7659 -14.5008 4.80913 14.0157 -8623 4 19.6887 6.47111 13.6446 7.23462 -2.42447 -18.0556 -8624 4 20.266 6.55226 12.115 5.2883 -10.9354 6.21868 -8625 6 32.4266 37.4954 40.1172 13.7501 31.88 -47.4625 -8626 4 32.7425 36.6266 39.9032 -2.48661 -20.9779 5.59445 -8627 4 32.1419 37.5817 40.9958 -11.8933 -10.3197 48.8363 -8628 6 39.7596 0.337115 6.09995 15.1421 -1.66777 24.2876 -8629 4 40.1534 1.22219 6.08152 -5.11901 -0.972083 -7.53812 -8630 4 40.1657 41.8549 6.90018 -9.37436 -2.20237 -11.3555 -8631 6 28.7751 10.1584 29.138 -2.01192 2.80513 -2.93319 -8632 4 27.8238 10.1744 29.001 -3.57801 1.81269 -4.50746 -8633 4 28.8919 9.80572 30.0274 6.34341 -2.0407 -1.56061 -8634 6 28.3442 21.074 10.6333 2.67716 -1.32955 -8.08167 -8635 4 28.7162 21.9756 10.7458 1.68682 -14.6392 -2.70928 -8636 4 28.9848 20.5267 10.1317 -8.30024 16.2649 10.4277 -8637 6 27.0693 28.6863 20.8775 28.7719 -2.37794 4.3254 -8638 4 27.7298 29.2434 21.3283 -4.93173 -3.86203 -1.8773 -8639 4 26.2334 28.9344 21.2444 -24.6691 6.36732 10.1211 -8640 6 39.6873 13.9804 33.4544 10.1398 -5.61125 10.7915 -8641 4 40.0465 13.7022 34.3167 -4.86 2.4669 -10.6871 -8642 4 38.7726 13.6755 33.4723 -5.1401 -2.85022 0.606476 -8643 6 25.4597 11.6576 34.3181 14.491 -28.0098 33.8508 -8644 4 24.8514 11.0162 34.7619 5.36553 12.2612 -15.2396 -8645 4 25.0161 12.1454 33.6493 -21.152 12.7672 -16.4478 -8646 6 27.5131 37.6326 21.427 -19.9573 -21.9997 -23.7283 -8647 4 28.2253 37.2064 20.96 8.67225 -9.05343 -17.242 -8648 4 27.9596 38.068 22.1137 20.557 20.5047 35.0331 -8649 6 30.5914 20.0695 28.6348 27.7431 -17.6396 19.2377 -8650 4 30.9836 19.3645 29.1801 11.8534 20.0629 -12.5158 -8651 4 29.6982 19.8076 28.6872 -39.6618 5.20089 -10.7407 -8652 6 42.3778 1.85684 14.9393 25.4983 -1.50621 30.9456 -8653 4 41.9471 2.41032 15.6124 -5.43016 1.03086 -4.74891 -8654 4 41.8361 1.80616 14.1675 -19.8596 2.00334 -17.6468 -8655 6 12.1616 12.5321 19.523 -14.5305 -6.69845 -4.01711 -8656 4 12.9939 12.0448 19.446 -0.641831 -5.10207 -0.17564 -8657 4 11.4028 11.9007 19.4323 17.6183 8.93718 0.635936 -8658 6 19.2173 1.21358 16.3673 12.2327 1.89672 9.92834 -8659 4 19.755 0.600796 16.911 -5.77615 9.45405 -9.5745 -8660 4 19.8129 1.9499 16.1364 -2.75311 -6.47505 -0.557351 -8661 6 9.48027 16.145 27.6887 18.4383 23.7652 -21.1678 -8662 4 9.95062 16.009 26.8224 -12.6846 -2.19341 25.2173 -8663 4 9.19893 15.3052 28.0262 -3.30777 -17.5687 0.945009 -8664 6 40.4566 26.1709 24.7821 -20.4805 41.2174 -0.532491 -8665 4 40.3628 26.7039 25.5991 10.1463 -19.7663 1.05084 -8666 4 40.0809 26.8306 24.1463 10.2053 -25.1837 1.88999 -8667 6 47.6675 17.6506 18.0225 -30.0634 41.3074 12.2788 -8668 4 48.2543 17.9981 18.7254 0.401995 -10.3127 -9.33209 -8669 4 46.9068 18.3177 18.0388 29.0716 -28.5939 -1.2112 -8670 6 36.6158 25.2629 4.18774 29.3736 28.0527 4.32129 -8671 4 36.5214 25.5758 5.09839 -16.0305 -5.04511 0.138651 -8672 4 37.2819 25.9232 3.86538 -16.6324 -17.2389 -6.3952 -8673 6 39.5728 35.3879 29.6636 12.278 22.7044 -7.26925 -8674 4 39.0499 34.5938 29.661 -5.91236 -8.06683 2.48368 -8675 4 39.3907 35.9006 30.4607 -1.7908 -9.53931 -1.38728 -8676 6 0.412001 14.6096 13.3342 2.26376 -2.5079 -14.7045 -8677 4 54.7802 15.2759 13.6175 -3.32355 6.27336 -0.974202 -8678 4 0.516441 14.0579 14.0961 4.60085 -12.9246 15.0473 -8679 6 12.196 27.3305 8.43326 10.0473 13.6833 14.0535 -8680 4 13.031 26.8669 8.51701 2.31971 -16.5604 -6.51009 -8681 4 12.4357 28.1833 8.85089 -17.0888 -3.60228 -10.1051 -8682 6 36.9057 14.8161 21.1198 30.6025 20.2317 -25.7914 -8683 4 37.0125 14.4244 21.9807 1.92342 -10.2074 20.832 -8684 4 37.7936 15.2053 20.874 -24.9082 -16.5351 5.08732 -8685 6 20.8486 4.94275 21.105 17.9022 -6.61396 -0.309651 -8686 4 20.374 5.67415 21.5228 9.17185 2.06744 3.08402 -8687 4 21.7751 4.88103 21.448 -24.8745 1.45604 -2.42669 -8688 6 36.7441 1.80601 7.63303 -8.86792 14.8212 -18.8361 -8689 4 36.3577 2.71345 7.77493 14.0998 -30.8697 16.0099 -8690 4 36.9898 1.34966 8.45182 -6.21638 14.7491 3.51078 -8691 6 12.2291 31.5076 37.4606 -20.8205 4.71929 16.9336 -8692 4 12.7789 31.2189 36.7301 -1.71439 -5.19212 -6.77065 -8693 4 11.3837 31.0118 37.4916 13.4088 3.21935 -3.86138 -8694 6 38.9875 41.6041 16.8806 -4.97036 -4.86794 -9.64455 -8695 4 39.4307 41.5716 16.0177 3.10466 0.790549 7.7281 -8696 4 39.367 0.410173 17.3903 6.57234 9.13046 2.45051 -8697 6 31.8971 27.2651 22.2536 0.475946 9.95506 -26.8482 -8698 4 31.2288 26.6192 22.5148 1.53167 3.01995 -0.700727 -8699 4 31.6701 27.5469 21.3168 1.33988 -13.0026 32.8364 -8700 6 42.7373 9.18402 25.5752 -16.5205 -8.12573 12.5156 -8701 4 42.0715 8.82875 24.9549 8.97347 3.93682 -3.18445 -8702 4 43.4726 9.55718 25.0966 9.17117 4.66181 -14.1392 -8703 6 50.9317 28.1762 25.3585 1.81467 11.9603 16.0249 -8704 4 50.4332 27.6858 24.699 -7.797 -4.30978 2.61883 -8705 4 50.6061 27.9816 26.259 1.82058 -3.16123 -16.2825 -8706 6 43.2019 19.6758 30.9261 -60.5069 12.608 18.1565 -8707 4 44.1121 19.7947 30.8273 58.227 11.7487 -4.80009 -8708 4 42.8317 20.4979 31.3452 14.2318 -14.5845 -6.94071 -8709 6 30.6579 14.0392 40.8099 -3.90856 28.8453 32.4485 -8710 4 30.2625 14.437 41.6588 6.78025 -22.1962 -33.7862 -8711 4 30.2388 13.192 40.6401 -8.31431 -9.09038 5.19898 -8712 6 20.9126 15.487 23.0255 1.81996 -1.2716 -0.577536 -8713 4 20.3529 16.1851 23.4151 9.86352 -5.06847 -1.26552 -8714 4 21.845 15.6804 23.2451 -11.0139 0.781722 1.09061 -8715 6 34.2266 0.759926 35.8266 5.91607 -35.831 36.3238 -8716 4 34.6699 1.4486 36.3596 -6.19332 -9.6922 -6.67054 -8717 4 34.0788 41.8551 36.4474 5.42693 41.8664 -30.5853 -8718 6 38.9146 36.9114 35.918 21.2173 -10.8751 17.2864 -8719 4 39.7829 37.095 36.338 -12.434 5.66027 -11.9648 -8720 4 38.7157 36.033 36.27 -5.46808 2.11761 -7.10044 -8721 6 45.1412 25.209 22.7799 -9.21588 11.7282 35.1943 -8722 4 44.1635 25.1535 22.9277 18.3683 -4.67801 -8.38153 -8723 4 45.395 24.8019 21.9606 -9.08047 -9.94082 -17.9945 -8724 6 40.6079 0.819632 35.9543 -10.1658 30.0784 -5.29357 -8725 4 40.5743 41.7978 35.9297 8.39322 -37.6139 4.80851 -8726 4 39.8853 1.04128 35.3423 10.5918 6.58535 9.58714 -8727 6 11.0481 28.354 35.0263 -7.05837 2.15472 6.15391 -8728 4 11.0065 27.7661 35.7937 6.20016 -1.50115 -1.31869 -8729 4 10.2774 28.923 35.1598 -2.00076 2.29074 -4.05614 -8730 6 20.214 13.5993 35.8619 28.0429 -16.4719 23.5579 -8731 4 19.4963 13.9327 35.3857 -45.1468 12.1599 -23.9045 -8732 4 20.9404 14.0304 35.4284 21.7873 4.64258 -6.99651 -8733 6 39.6259 5.13927 1.77541 6.3837 10.5905 23.0009 -8734 4 38.815 4.76887 1.43754 -8.89155 -4.8304 -7.9643 -8735 4 40.2998 5.10051 1.09544 5.70124 1.55861 -13.0764 -8736 6 30.2644 30.8765 32.4376 2.45351 13.5189 11.7538 -8737 4 29.6638 31.1848 33.1457 1.37952 -7.29152 -6.97913 -8738 4 29.9065 30.0722 32.0512 -6.5155 -7.29863 -0.0927806 -8739 6 14.5561 10.991 22.8667 10.081 16.7623 43.7388 -8740 4 15.1677 11.6459 23.3133 -13.9792 -18.4015 -26.7579 -8741 4 13.9431 10.829 23.6181 3.59137 -7.6484 -17.8174 -8742 6 20.7554 13.9367 3.0184 -22.7431 -13.2276 -14.851 -8743 4 19.9027 13.7405 2.57467 24.082 -4.954 3.77469 -8744 4 20.4786 14.7044 3.49738 5.42185 19.6619 18.2233 -8745 6 41.2999 4.28373 12.6115 -5.11846 11.2121 16.06 -8746 4 40.5902 3.66826 12.7964 -5.45414 -3.74116 2.1628 -8747 4 41.646 4.04628 11.766 6.8814 -9.70345 -22.8074 -8748 6 10.8486 24.7151 21.7079 -22.0181 20.7635 -2.99902 -8749 4 10.06 25.055 21.1824 26.1755 -20.3138 8.68391 -8750 4 11.196 23.8735 21.3742 -8.74412 -0.217035 -8.2032 -8751 6 53.5851 20.8962 34.3615 -20.5776 4.99959 -7.54911 -8752 4 54.5312 20.9399 34.3174 23.7346 3.60458 -0.717784 -8753 4 53.3344 20.0378 34.731 7.46747 5.54606 -4.26157 -8754 6 14.8822 4.84805 30.4483 -9.71325 -6.00753 -19.6684 -8755 4 14.771 4.94284 29.4789 1.77408 0.90497 14.7496 -8756 4 14.5561 3.94513 30.5986 4.49673 6.24836 5.5759 -8757 6 48.9024 37.1196 13.1149 -36.5603 24.8322 -14.1851 -8758 4 47.9606 37.2057 13.4129 22.1922 -3.12109 -3.19476 -8759 4 49.2987 36.4589 13.6532 13.3268 -16.5999 12.901 -8760 6 26.8059 19.3169 7.54434 -4.26945 -4.42367 7.83904 -8761 4 27.1766 18.4867 7.22339 -3.92405 -4.32352 -1.07463 -8762 4 27.3968 19.9842 7.20607 8.782 12.6164 -5.40832 -8763 6 17.6305 11.9358 39.0864 -20.6439 9.19078 16.9487 -8764 4 18.5077 11.609 39.0209 28.8526 -12.5757 -8.06323 -8765 4 17.5232 12.1203 40.0373 -6.81014 1.23205 -8.73836 -8766 6 49.927 14.591 8.61416 15.5742 -26.1486 -8.96269 -8767 4 49.2009 13.9524 8.72368 2.87529 10.9098 3.94828 -8768 4 49.6414 15.4659 8.85563 -10.1676 20.5637 7.32703 -8769 6 32.3582 34.9735 31.5167 -0.414276 11.4895 24.1707 -8770 4 32.1283 34.3825 30.8126 -1.81559 -4.89127 -12.898 -8771 4 32.4479 35.8663 31.1601 -0.97656 -3.19104 -3.1743 -8772 6 11.821 22.2226 21.3194 1.12988 -20.2292 -31.7924 -8773 4 12.2035 21.6949 20.5593 -17.646 16.3031 19.3587 -8774 4 12.5076 22.1609 21.967 14.4856 1.86701 17.8995 -8775 6 33.8479 9.95925 13.6297 5.85555 4.94861 0.641841 -8776 4 32.9412 9.60258 13.4965 20.4646 2.44791 -13.0803 -8777 4 34.46 9.81143 12.8638 -25.0852 -4.3509 9.75457 -8778 6 25.5216 36.3896 1.4985 -3.83916 -1.90754 -5.44184 -8779 4 26.1733 36.851 0.947779 -3.43756 3.58217 3.68691 -8780 4 24.6678 36.8514 1.38848 10.8858 -3.23471 -1.95008 -8781 6 26.2654 10.5456 9.75524 -44.5011 8.64206 25.1655 -8782 4 25.6084 11.269 9.60979 18.788 -4.56637 -6.88642 -8783 4 25.8198 10.0845 10.5139 21.0346 7.54764 -16.1236 -8784 6 25.0247 0.792222 40.9035 16.6629 9.7536 -9.8108 -8785 4 25.2766 0.410293 40.0414 -7.0744 -0.853038 7.71488 -8786 4 25.4535 1.67289 40.8914 -6.39875 -10.0211 5.33714 -8787 6 46.2514 3.92331 24.811 2.29787 -10.4124 3.565 -8788 4 46.4476 4.07649 23.8793 1.84574 -7.0337 -1.43198 -8789 4 46.0806 2.96577 24.928 -3.00701 8.9366 -8.52535 -8790 6 21.593 13.605 29.211 2.46069 1.87638 12.7155 -8791 4 21.5518 14.2847 29.9136 -0.977025 -6.07097 -8.18011 -8792 4 21.3035 14.062 28.4178 -1.02829 3.62716 -1.29843 -8793 6 36.772 38.3747 0.364057 -13.57 -14.6746 -5.92565 -8794 4 36.4241 39.1227 0.863015 -2.10343 5.30459 -0.282121 -8795 4 36.0255 37.7419 0.250491 13.2024 11.0478 3.68109 -8796 6 19.3024 17.6377 24.0664 34.4056 30.1631 -22.0465 -8797 4 18.4191 17.3498 24.1437 -40.9446 -15.7866 5.54764 -8798 4 19.2946 18.2748 23.3003 0.347271 -14.2409 17.5238 -8799 6 23.1729 12.6936 3.50527 -23.4203 -1.67393 -9.32385 -8800 4 22.2599 12.987 3.28408 10.1497 2.83055 6.60862 -8801 4 23.2366 11.8468 3.05081 2.04707 -0.882582 2.79058 -8802 6 37.8929 8.88926 35.4532 -15.1513 -19.5409 -35.7954 -8803 4 38.8496 8.85033 35.2802 -3.80753 -1.00094 -0.145651 -8804 4 37.4409 8.32345 34.738 24.7998 24.8105 28.8968 -8805 6 14.3214 15.124 36.1936 10.1777 -8.45579 -11.337 -8806 4 15.1189 15.6285 36.3983 0.383997 -0.909139 3.4786 -8807 4 13.728 15.2114 36.9249 -8.84751 6.7001 14.2991 -8808 6 35.0764 0.951221 33.027 4.39995 -0.747562 -23.3066 -8809 4 34.9707 1.92678 33.0471 -0.901583 -14.825 16.9845 -8810 4 34.929 0.489106 33.8671 -4.79444 18.9729 2.67887 -8811 6 50.9368 0.508345 17.9996 -16.1068 -2.11236 -10.8013 -8812 4 50.7363 1.3993 17.6607 6.59543 -7.82408 5.75367 -8813 4 50.2126 41.8571 17.6452 15.113 5.01242 7.08044 -8814 6 26.2276 30.5707 0.943679 2.98972 25.4521 29.679 -8815 4 26.9747 31.0717 1.30878 -11.5718 -5.07384 -0.177367 -8816 4 26.5685 30.1289 0.190254 7.28539 -15.5247 -23.6744 -8817 6 18.5631 38.2963 4.56281 15.0547 -0.00169581 -1.07608 -8818 4 17.6313 38.4808 4.44067 -9.04909 6.52025 -3.84653 -8819 4 19.0145 38.7079 3.79419 -7.75189 -5.39823 9.30868 -8820 6 31.1327 5.08368 4.10816 20.0095 -18.3558 -6.33253 -8821 4 31.8391 4.51927 4.54922 -26.0459 18.0586 -17.7145 -8822 4 31.2112 4.96997 3.12633 -1.20575 2.29654 19.098 -8823 6 26.4386 21.9021 1.48262 11.6176 -12.3641 -2.34526 -8824 4 26.4119 22.77 1.11333 -7.24657 26.8604 -8.21156 -8825 4 27.3591 21.6321 1.37052 -1.3799 -4.61827 0.12427 -8826 6 39.218 11.6975 22.8013 10.5737 17.0434 4.86912 -8827 4 39.8837 11.6898 23.5135 -8.12783 -9.21376 -3.17514 -8828 4 38.7576 10.8611 22.7762 -0.316566 -9.51531 5.7902 -8829 6 13.6104 36.3454 30.6448 12.2201 31.8005 15.4331 -8830 4 13.9411 37.0787 31.1944 -5.64032 -6.12374 -20.8561 -8831 4 13.4819 35.6769 31.3099 -5.82879 -19.5305 -1.97286 -8832 6 50.5737 9.8729 9.34449 -28.5439 -15.8542 -0.594603 -8833 4 49.6941 9.5296 9.68217 24.5077 10.0039 -8.16891 -8834 4 50.7802 10.6382 9.87905 1.56032 8.49656 8.37591 -8835 6 49.6568 40.2957 22.5808 3.13406 -4.17489 -1.45496 -8836 4 49.9643 39.4131 22.2832 -6.04563 10.523 5.74674 -8837 4 49.4657 40.2311 23.537 6.08697 -6.10842 -7.72776 -8838 6 7.19984 41.3227 28.8903 -1.52952 20.6044 28.9443 -8839 4 7.18166 41.5789 29.8666 2.82963 -8.74683 -37.3978 -8840 4 7.33954 0.237732 28.3754 1.09714 -11.2116 9.436 -8841 6 13.0357 18.018 25.3358 19.442 16.9905 44.3108 -8842 4 13.6166 18.1186 24.5548 -1.12298 4.17303 17.3747 -8843 4 13.5323 18.3306 26.2146 -21.9746 -20.4015 -59.5043 -8844 6 50.052 19.589 2.43093 38.9512 -4.48133 -22.8803 -8845 4 50.7424 19.2598 1.79532 -23.4729 1.49397 14.1456 -8846 4 50.5528 20.298 2.8491 -7.87613 8.00017 8.65361 -8847 6 28.349 40.9814 24.5177 14.9096 -9.01222 -0.77751 -8848 4 28.8235 40.5955 23.7606 -4.31864 4.07524 4.80921 -8849 4 27.7156 41.5877 24.1507 -14.6867 11.3415 -7.76415 -8850 6 19.4129 5.36023 29.5381 -15.1481 -17.3665 11.3948 -8851 4 20.1134 5.96028 29.2689 3.1753 8.4576 0.913483 -8852 4 18.7407 5.8353 30.064 8.44892 1.72514 -6.85652 -8853 6 35.3149 40.1584 22.2743 -5.4761 3.67764 -22.0922 -8854 4 35.6772 39.8166 23.0859 3.70556 0.822605 11.3301 -8855 4 35.3088 41.1243 22.2924 6.6179 -0.993945 11.5959 -8856 6 16.1846 33.7767 9.75922 -0.358556 8.53088 17.0233 -8857 4 15.9516 33.2005 9.03859 1.48669 -13.8429 -11.0903 -8858 4 15.6081 34.5411 9.70154 -4.21994 3.45608 -1.0308 -8859 6 17.3638 40.6569 20.2187 0.0478101 13.797 12.0053 -8860 4 17.2553 39.7868 20.6094 -1.96745 -8.64858 -4.42208 -8861 4 17.5346 41.2369 20.9867 0.609446 0.00823871 -10.958 -8862 6 20.5168 9.71855 9.57392 23.3053 8.23996 -15.5036 -8863 4 21.1612 10.0129 10.2371 -5.46071 -1.58749 -5.90152 -8864 4 19.8092 9.36498 10.0856 -20.4585 -11.5711 12.7624 -8865 6 47.4431 20.1927 21.3797 46.3705 -23.5901 12.8176 -8866 4 48.2534 19.5912 21.2825 -32.1103 24.8918 7.30718 -8867 4 46.9863 20.0806 20.5604 -17.463 -0.0836882 -22.1962 -8868 6 38.4119 40.7863 37.8131 4.58972 -16.3007 -8.86139 -8869 4 38.2015 41.716 37.7675 -2.07213 19.1933 -0.538509 -8870 4 38.1163 40.4897 38.6817 -2.89344 0.451293 5.51523 -8871 6 4.78246 1.95264 13.1142 -0.962758 -11.3299 -4.56483 -8872 4 4.86308 1.24617 12.4504 1.09441 11.0888 1.2667 -8873 4 4.58181 1.48453 13.9266 -0.88642 0.622503 9.15822 -8874 6 46.8366 29.0044 2.17213 -21.5573 10.7483 2.0879 -8875 4 46.5703 29.0979 3.11526 14.9241 -10.138 -17.8178 -8876 4 47.6533 28.5191 2.04264 7.39387 -6.09514 13.7966 -8877 6 37.4332 26.1628 25.6457 0.476866 -1.57884 -3.35254 -8878 4 37.1432 25.5044 26.2761 -1.46501 -6.7424 3.65975 -8879 4 36.6379 26.5951 25.3475 -3.92424 6.80267 -0.609098 -8880 6 27.3215 4.19863 19.437 6.03131 -5.89417 1.59018 -8881 4 28.0693 4.5088 18.8685 -19.6633 0.0824503 4.70742 -8882 4 26.4692 4.57526 19.1444 8.48727 3.90116 -6.43998 -8883 6 29.5816 35.1763 32.6702 11.3433 -15.1984 -13.0035 -8884 4 29.498 34.4257 32.0309 -0.34209 19.1564 15.9908 -8885 4 30.487 35.489 32.5363 -2.16348 -1.10322 -0.755163 -8886 6 51.6039 27.3804 34.6228 -16.2846 20.7721 3.47149 -8887 4 51.9118 26.5342 34.8842 8.46829 -31.6815 14.0056 -8888 4 52.043 27.5552 33.7939 4.07896 7.882 -12.2594 -8889 6 26.213 15.718 22.6983 4.45652 -13.2698 4.19624 -8890 4 25.9644 16.5706 22.3629 -2.74203 26.12 0.0562263 -8891 4 25.9462 15.1046 22.0171 -4.99078 -11.3651 -6.14484 -8892 6 36.1284 41.1872 15.4686 -15.9675 5.34592 -0.326298 -8893 4 35.5872 40.4009 15.2728 11.0637 0.363161 -0.898578 -8894 4 37.0593 40.962 15.4319 4.98109 -12.2962 -3.97184 -8895 6 18.4605 8.81439 11.2163 9.85092 25.9028 -2.05591 -8896 4 18.8222 8.21565 11.8732 -2.65799 -9.87079 3.83174 -8897 4 17.6938 8.4288 10.8111 -9.58752 -11.4871 -1.05984 -8898 6 30.2054 21.3176 23.2008 0.0321998 2.06754 0.100272 -8899 4 29.9991 22.2239 22.9456 -2.76699 -3.99559 -1.97847 -8900 4 29.5697 20.7243 22.7648 2.21136 7.68347 0.454199 -8901 6 22.7376 2.20942 34.8415 -7.06988 -25.8748 21.345 -8902 4 22.3263 1.32441 34.7915 6.81547 13.2405 5.99888 -8903 4 22.6443 2.51876 33.959 0.748808 17.6695 -28.972 -8904 6 12.6779 2.74229 12.3423 -3.02369 13.9186 -14.8572 -8905 4 12.6684 3.63953 11.9163 1.20981 -22.4864 12.4813 -8906 4 13.1874 2.20366 11.7175 -0.841633 0.53426 4.77071 -8907 6 24.0891 30.0714 14.5767 2.26717 -13.4561 -11.586 -8908 4 23.8674 30.8343 15.1637 -15.8173 -12.4528 -15.4046 -8909 4 23.3482 29.6562 14.0436 11.1594 27.3113 22.4963 -8910 6 0.0169515 27.9037 22.8558 -22.9231 2.02358 -4.19556 -8911 4 54.5653 28.3586 23.5905 7.88497 -1.22395 1.09473 -8912 4 54.2173 27.7016 22.3138 13.4725 -1.40758 1.11908 -8913 6 12.3768 4.48401 25.8984 -1.01368 1.72138 -1.86924 -8914 4 11.999 5.34556 25.8124 1.61778 23.022 -11.6285 -8915 4 11.6412 4.07623 26.3496 -0.520107 -24.5543 7.98643 -8916 6 50.6552 14.4595 5.90563 -9.7075 2.6569 37.2621 -8917 4 51.421 15.0215 5.71422 1.2699 0.536098 -2.53407 -8918 4 50.4862 14.5526 6.9139 5.60038 -4.97296 -46.1729 -8919 6 52.566 22.8545 20.1304 -1.0263 1.56712 -17.1158 -8920 4 52.8493 23.3468 20.8979 1.30497 -0.175929 17.7779 -8921 4 52.7622 23.494 19.4302 -3.4332 -7.01119 -2.14697 -8922 6 43.5747 16.5432 12.8706 26.1082 -6.15301 -20.1459 -8923 4 44.3581 16.1075 12.4177 -27.2623 16.7463 17.9516 -8924 4 42.8105 16.3628 12.3102 -5.85283 0.59737 -2.51971 -8925 6 15.9643 16.7491 40.5889 4.71604 31.6512 -1.38133 -8926 4 16.4157 17.2981 39.8953 -10.7397 -16.8436 16.4649 -8927 4 15.6568 17.4119 41.253 8.12177 -13.8769 -14.2686 -8928 6 23.4093 18.8548 23.8539 -16.419 -4.21219 2.12821 -8929 4 23.4427 19.3457 24.6888 0.296298 -1.81048 -2.30579 -8930 4 22.5005 18.9913 23.5305 9.65682 -2.29273 2.24785 -8931 6 46.4286 3.27372 31.8783 1.50761 -1.36157 -5.63512 -8932 4 45.559 3.26328 31.468 -2.27736 -0.687336 -10.0334 -8933 4 46.2409 3.35124 32.8099 7.04458 2.11131 4.36323 -8934 6 43.404 41.0501 12.2894 -4.74196 -21.563 6.60959 -8935 4 43.6943 41.7945 12.8025 5.82787 10.392 6.16968 -8936 4 43.4921 41.2918 11.3656 -0.276957 5.00436 -10.4807 -8937 6 7.4944 32.479 29.5886 4.16519 42.7458 -9.72808 -8938 4 8.11522 31.7905 29.7504 15.4265 -22.4366 1.70525 -8939 4 8.06583 33.2868 29.4339 -18.9062 -19.2919 1.43274 -8940 6 4.77786 31.6555 22.5097 8.01353 -0.237295 6.09653 -8941 4 5.36252 32.2279 23.0433 -12.0801 1.27555 -9.50519 -8942 4 4.10079 32.1892 22.0697 5.55495 3.82082 5.5049 -8943 6 48.8707 26.8644 2.67473 3.24755 -50.1854 9.90243 -8944 4 49.7841 26.6767 3.05593 -33.5394 4.93648 -17.7122 -8945 4 48.3402 25.9967 2.74374 27.3415 43.0547 -3.91521 -8946 6 35.3704 23.2724 21.6151 -20.572 -8.60634 18.7236 -8947 4 36.1531 22.7653 21.8467 10.3528 0.763668 -1.9928 -8948 4 35.5272 23.8633 20.8878 14.153 10.3741 -19.8739 -8949 6 9.81162 37.7752 27.3066 -7.93747 -1.88745 -15.4111 -8950 4 9.56608 38.5967 27.7736 11.3364 -13.9943 4.65066 -8951 4 10.53 37.2723 27.7168 -2.00951 8.75096 9.6206 -8952 6 6.95784 10.9804 26.0002 -14.8513 -9.26658 -13.6642 -8953 4 6.43708 10.2284 25.6287 17.7452 16.2397 9.86134 -8954 4 7.32481 10.7062 26.8445 2.87033 -7.35616 11.341 -8955 6 15.9925 34.488 38.9165 -7.91378 13.4212 -4.2482 -8956 4 16.1125 33.5888 38.5756 -0.423195 -0.537141 7.5048 -8957 4 15.8451 34.497 39.8859 4.12272 -10.609 -16.5735 -8958 6 24.136 17.3087 36.1669 -1.30362 -38.1211 0.134245 -8959 4 24.6388 17.5417 36.9612 2.54889 -4.89456 5.81445 -8960 4 24.0565 16.298 36.169 6.29988 31.3296 1.89661 -8961 6 29.9661 19.0481 5.63552 -3.51045 -24.0694 26.081 -8962 4 30.059 18.4844 6.44318 1.40084 7.89656 -22.1005 -8963 4 29.4651 19.7932 5.9612 -6.50009 17.0844 0.645364 -8964 6 41.2323 14.2118 25.8708 0.538972 29.9242 -13.4546 -8965 4 41.1167 15.1135 25.4912 3.21098 -20.1981 4.76589 -8966 4 41.3237 14.3734 26.8138 2.01946 -2.10135 6.77926 -8967 6 30.5977 17.7991 37.3648 -2.09385 13.2702 -7.29075 -8968 4 30.1274 18.3693 36.6865 13.7219 -8.47854 26.2153 -8969 4 30.6897 18.2674 38.2325 -7.09621 1.58925 -18.9017 -8970 6 36.2622 35.7606 28.8616 -21.9344 -15.8478 13.9239 -8971 4 36.666 34.9659 29.2737 0.470987 14.2463 -5.72758 -8972 4 36.9609 36.34 28.5862 17.8584 7.52692 -3.58957 -8973 6 0.186361 37.881 20.3783 -19.4052 1.06805 -13.5296 -8974 4 0.625244 37.258 20.9754 1.43275 1.23053 -1.08677 -8975 4 54.3963 37.4077 20.0073 13.2242 8.68111 6.51083 -8976 6 49.5157 39.5849 25.2719 1.34086 -27.0873 28.6785 -8977 4 49.1738 39.8396 26.1677 9.83442 -4.23573 -27.15 -8978 4 49.8309 38.6394 25.3482 -11.1501 31.2987 0.525887 -8979 6 21.6501 10.2052 29.3652 1.38747 -32.8599 -17.8213 -8980 4 21.4815 11.1062 29.1158 -2.57329 19.5966 11.1399 -8981 4 21.7962 10.0736 30.3036 1.32123 13.0863 10.38 -8982 6 36.4484 30.062 0.133613 20.0221 49.2239 1.07318 -8983 4 36.3691 29.4748 41.3122 -8.72629 -28.1564 -18.1683 -8984 4 36.9877 30.812 41.6437 -16.8233 -22.5363 23.3328 -8985 6 35.2366 23.3806 39.1473 20.2218 -67.2813 -35.6269 -8986 4 34.8925 23.3776 38.2436 -2.85003 -5.00903 7.3464 -8987 4 34.9678 24.1769 39.4749 -24.7984 75.1446 29.9953 -8988 6 25.4958 17.6356 38.7131 -1.05403 5.23051 -13.5311 -8989 4 26.2557 17.1099 38.9745 11.6052 -6.82876 2.03202 -8990 4 25.6896 18.4914 39.1039 0.551448 5.55093 4.31103 -8991 6 32.6851 1.71412 15.3757 -17.1832 -26.0249 32.2484 -8992 4 32.9133 1.90091 16.3255 -0.281287 1.06348 -22.8896 -8993 4 32.1369 0.878474 15.451 14.5551 28.5253 -7.92953 -8994 6 2.74577 26.2334 40.164 -3.83079 -17.2464 -24.8373 -8995 4 2.52975 26.8073 40.8689 -10.0885 25.811 23.4985 -8996 4 3.46379 25.6906 40.4857 13.7859 -11.3271 -3.22577 -8997 6 25.4247 39.5803 6.65235 -3.20662 25.1889 -29.4644 -8998 4 26.0108 39.0547 7.19361 -10.0861 -10.9475 13.3666 -8999 4 24.4797 39.508 6.87242 11.3389 -11.2764 10.0712 -9000 6 3.89558 2.45526 21.1915 20.3615 -74.5786 -16.468 -9001 4 3.45835 1.54866 20.9342 19.9424 46.4596 11.9477 -9002 4 3.20863 3.06758 21.3193 -35.5841 29.5388 2.2294 -9003 6 19.428 35.9937 6.17834 -35.0483 8.79483 10.2733 -9004 4 18.6638 35.8781 6.77432 14.6839 -5.07873 0.0324743 -9005 4 19.0495 36.6291 5.56439 9.71061 8.85688 -10.7695 -9006 6 53.6717 10.8593 34.7958 -7.0633 -31.3632 -8.45381 -9007 4 53.6341 10.4895 35.6991 7.39736 18.8685 -12.2464 -9008 4 53.8829 11.7827 34.7263 4.03482 19.5096 16.0301 -9009 6 51.2684 14.0949 34.672 -8.65676 -1.63762 -26.9588 -9010 4 50.7715 13.5641 33.9816 13.3581 12.906 22.4054 -9011 4 51.0369 13.7812 35.5532 -5.90867 -9.66849 3.74112 -9012 6 14.4369 40.0234 28.032 -17.7583 12.3896 33.8878 -9013 4 13.8707 39.2432 27.9284 6.73847 -3.79593 -5.43806 -9014 4 14.0697 40.4885 28.8439 14.5888 -10.3946 -25.5694 -9015 6 36.0586 40.8581 1.30985 34.3129 5.11816 -1.28261 -9016 4 35.3876 41.022 1.96214 -5.4524 5.11716 12.4526 -9017 4 36.8901 41.3246 1.61712 -30.5352 -10.0787 -2.88322 -9018 6 32.5955 21.8673 9.61487 11.2903 3.47268 22.8686 -9019 4 32.2562 21.1899 9.03409 -3.19899 -6.31213 -16.1683 -9020 4 32.8032 22.6511 9.09762 -2.66985 0.307575 -11.8305 -9021 6 53.7554 11.4583 10.0657 12.5408 -15.0223 -21.3323 -9022 4 54.7025 11.5478 10.261 -4.15933 2.55001 3.12883 -9023 4 53.7605 10.7769 9.36125 -9.51558 7.63224 9.70748 -9024 6 25.4365 2.06658 35.0039 -16.8474 18.4627 -14.151 -9025 4 25.5892 2.94197 34.5728 -1.09755 -16.5277 9.12484 -9026 4 24.4603 2.05675 35.1439 15.8828 -2.54758 -2.86629 -9027 6 38.4258 16.3759 27.0837 10.3035 -3.82582 33.4754 -9028 4 38.4229 16.0362 28.0039 4.2105 -6.34073 -14.2668 -9029 4 38.1536 17.2766 27.2341 -1.96409 14.1736 -9.55492 -9030 6 11.9898 11.8134 38.076 -13.826 -2.82892 7.4824 -9031 4 12.2944 12.4411 38.7385 15.2198 2.85174 -2.31876 -9032 4 11.0532 11.721 38.3132 2.05768 -5.32701 -10.6008 -9033 6 21.1746 40.7334 25.8979 40.4357 -13.6237 -24.6728 -9034 4 20.6698 41.4315 25.4918 -16.6357 14.348 -0.996217 -9035 4 20.789 40.494 26.7242 -19.3448 -1.94923 24.9485 -9036 6 5.46053 31.2633 28.1043 10.2831 7.82506 0.3012 -9037 4 4.85681 31.7249 27.5011 4.53193 2.9664 -2.03256 -9038 4 6.18919 31.875 28.3487 -9.19227 -4.78386 -2.03476 -9039 6 38.5722 10.4288 26.6273 1.75688 -6.42268 2.69181 -9040 4 39.2722 10.957 26.2192 0.13713 -2.38088 1.965 -9041 4 38.9883 9.93745 27.351 -0.726559 6.62326 -4.692 -9042 6 34.5654 22.2334 5.77474 -10.6824 6.04198 20.2303 -9043 4 33.6505 22.4646 6.03122 6.34024 -5.77168 -8.80249 -9044 4 35.1097 22.5906 6.49609 1.67963 -6.25138 -9.01327 -9045 6 19.5088 23.4111 8.91157 10.1707 -16.3121 14.7533 -9046 4 19.7449 23.1021 9.7973 -5.16612 6.6008 -0.0119594 -9047 4 19.9964 22.8054 8.35541 -0.106246 2.40248 -11.9056 -9048 6 19.7526 39.1673 18.9392 3.41392 2.41259 -7.44399 -9049 4 20.3112 38.9942 19.7162 -9.66179 4.90282 -1.08801 -9050 4 18.9888 39.695 19.2431 8.6955 -6.10904 -0.220035 -9051 6 19.0066 16.6479 37.8897 24.9266 -16.0788 2.00499 -9052 4 18.1904 16.5622 37.4269 -20.8911 -0.0800444 -12.5516 -9053 4 18.858 17.3198 38.5387 -2.83386 13.0664 11.2213 -9054 6 46.1457 18.3015 34.4662 -13.7163 3.02283 10.6817 -9055 4 46.1788 17.7584 33.6837 2.50627 -7.36872 -12.652 -9056 4 45.2295 18.6352 34.4793 7.83367 -3.11582 0.242547 -9057 6 37.6724 4.92727 10.6572 20.6306 -0.498941 -29.5329 -9058 4 38.5268 5.23995 10.2493 -20.9001 -6.48587 16.5696 -9059 4 37.1025 4.69637 9.88262 10.9132 7.05613 26.3995 -9060 6 51.9879 36.0003 6.84307 -0.0349375 1.28893 10.7684 -9061 4 52.0937 36.793 6.30051 2.19835 -5.62517 4.5242 -9062 4 52.7425 36.0295 7.48232 -7.26034 2.01661 -20.7899 -9063 6 26.6747 12.3215 0.993928 -15.5873 -26.456 -19.7503 -9064 4 26.4829 12.3908 1.92985 -0.4811 3.80705 11.7504 -9065 4 26.1241 11.5295 0.732228 15.7893 19.669 4.48242 -9066 6 51.344 35.7707 13.5244 -1.45768 15.8539 -2.86245 -9067 4 51.4515 36.3837 12.7824 1.55721 2.40741 1.90229 -9068 4 51.4783 34.9191 13.1366 6.57206 -21.9808 -6.55402 -9069 6 1.98876 3.63996 24.5779 3.53339 50.093 -23.5227 -9070 4 1.66274 3.05681 25.2088 -14.7773 -39.8355 33.4132 -9071 4 1.68527 4.50485 24.9411 8.95614 -12.6616 -11.2736 -9072 6 33.5242 15.2767 16.4494 0.0755523 4.59339 -41.038 -9073 4 33.5553 15.5138 15.4787 -3.36737 -9.15609 28.4742 -9074 4 33.81 16.089 16.8707 2.78154 5.67933 12.8052 -9075 6 10.7376 26.5972 37.3568 -53.543 46.6204 -3.13137 -9076 4 10.2745 27.0143 38.1249 4.48347 -4.84659 -12.5134 -9077 4 11.4659 26.2171 37.7527 59.8403 -33.1666 26.4091 -9078 6 39.618 8.36935 32.0025 -18.1555 9.41152 20.5333 -9079 4 39.1948 8.91554 32.6893 14.8148 -9.04413 -3.7523 -9080 4 39.059 8.55692 31.2545 -3.75745 -0.899113 -17.0741 -9081 6 48.8678 24.2325 11.5968 8.56011 -30.9839 -7.0275 -9082 4 49.2355 23.3258 11.4382 -10.5357 21.2684 5.64902 -9083 4 49.6052 24.6956 12.0119 -1.11745 3.30341 0.0123828 -9084 6 15.7966 8.52145 22.5402 1.04041 9.04678 1.57429 -9085 4 15.9271 8.56462 21.5825 -0.708828 -3.15413 5.43528 -9086 4 15.5351 9.42629 22.7739 -0.982858 -3.13072 -0.606507 -9087 6 16.9647 23.5461 7.94634 -33.4976 4.63454 -7.56842 -9088 4 17.0449 23.8842 7.03772 17.2153 -3.19264 11.7182 -9089 4 17.7681 23.4723 8.45101 25.4501 5.7081 -7.03081 -9090 6 42.4788 26.856 6.32162 3.09129 16.6976 -8.96027 -9091 4 41.8509 27.5547 6.55233 4.05081 -5.7053 1.31186 -9092 4 43.1337 27.3683 5.79469 -5.76138 -9.42264 4.17624 -9093 6 36.7899 4.80361 30.039 -6.11534 9.52442 2.68488 -9094 4 37.0233 4.89717 30.9689 4.03122 4.23205 -0.240484 -9095 4 36.2783 4.00567 29.9694 -7.15291 -10.8132 -0.980928 -9096 6 45.6188 11.6101 3.31184 17.0103 13.4398 12.4748 -9097 4 45.8378 10.6807 3.43524 1.11174 -8.0511 2.33471 -9098 4 46.2756 12.0957 3.86714 -12.3909 -9.3108 -12.4209 -9099 6 24.8953 36.3829 21.2888 -10.2051 -4.79955 -3.81503 -9100 4 24.4947 36.4635 22.1668 10.8854 5.06826 1.45383 -9101 4 25.816 36.6689 21.3407 0.621807 2.11968 6.76072 -9102 6 31.8152 24.7333 2.44905 16.2387 18.0677 -0.666362 -9103 4 31.5926 23.846 2.71622 -2.49338 -12.6998 4.18613 -9104 4 32.794 24.7683 2.43834 -16.3068 -2.39725 -1.0987 -9105 6 24.1315 21.9864 37.2328 -11.9778 41.7246 15.7453 -9106 4 24.1531 22.9879 37.1682 1.73438 -35.6656 2.36813 -9107 4 24.6319 21.6756 36.4808 8.45953 -1.72708 -12.6617 -9108 6 37.1993 11.5451 15.0492 16.5469 7.10484 -0.527568 -9109 4 37.9299 11.7412 15.6355 19.6925 -10.3737 -3.43176 -9110 4 36.5282 11.9944 15.5291 -36.4248 10.8574 4.75341 -9111 6 36.4804 20.3298 41.7865 -14.7619 -38.0306 11.4639 -9112 4 36.2972 19.4996 41.306 -2.7681 3.32899 7.9346 -9113 4 36.9128 20.8369 41.1399 19.1888 26.5648 -23.5244 -9114 6 32.0378 37.9251 32.6621 -20.5074 -27.3147 -8.21436 -9115 4 32.5159 38.6908 32.9558 4.48721 20.2349 -0.22713 -9116 4 31.3298 38.1855 32.0457 8.6638 5.37323 8.26506 -9117 6 12.0353 39.9275 22.5179 -19.9222 21.97 13.043 -9118 4 12.3148 40.8142 22.1582 -9.65836 -22.9721 12.3921 -9119 4 11.2968 40.0749 23.1753 26.4497 -1.81786 -22.4595 -9120 6 26.3421 1.33641 19.2861 18.8224 -12.0939 15.9617 -9121 4 26.8564 0.711595 19.8557 -14.3211 16.2919 -14.6989 -9122 4 26.7977 2.18849 19.3545 -2.53714 -0.144297 -3.51109 -9123 6 5.91333 14.3058 5.68279 5.58536 -17.6781 -26.1831 -9124 4 6.35226 14.1008 4.80839 -10.2521 5.5819 21.3359 -9125 4 5.1498 13.7016 5.72209 7.95548 1.62414 0.442017 -9126 6 13.3681 23.0924 19.1542 -7.87238 10.4677 13.234 -9127 4 14.1204 22.8148 18.6592 15.6827 -8.39443 -13.4152 -9128 4 13.7622 23.5769 19.9007 -5.90355 -3.89356 -3.96922 -9129 6 23.3981 15.0775 9.7431 -16.2896 3.15659 0.0853289 -9130 4 22.5416 14.6758 9.94236 4.38356 -3.66538 1.71341 -9131 4 23.1926 15.7004 9.03099 5.43777 4.93098 -2.67512 -9132 6 49.5886 13.8369 18.4468 -1.57371 0.160736 10.1606 -9133 4 48.8725 13.4353 17.9701 -17.3578 -11.6866 0.338485 -9134 4 50.0711 14.2256 17.7358 20.2332 17.1818 -14.445 -9135 6 41.7455 5.66741 41.8995 19.0031 1.14603 7.86728 -9136 4 42.5946 5.93333 0.438032 -19.5636 -6.95293 -12.6597 -9137 4 41.9891 5.05837 41.1762 -2.65724 5.24908 4.18535 -9138 6 17.2511 35.5417 2.55548 5.2045 0.397579 1.12894 -9139 4 18.2067 35.619 2.48098 6.39755 9.05508 3.07921 -9140 4 17.0886 34.6316 2.34229 -4.27489 -11.2961 -3.02567 -9141 6 49.7041 19.8589 40.2412 43.8428 -27.8149 3.09893 -9142 4 49.318 19.0163 40.5437 -5.31641 8.5833 -2.14336 -9143 4 50.6864 19.6533 40.2493 -27.6084 12.6334 -3.24012 -9144 6 38.3071 5.82731 32.0534 -20.9946 -3.84451 12.3853 -9145 4 37.8352 6.48986 32.6009 6.6943 -7.79079 -6.23381 -9146 4 39.2094 6.1245 32.003 13.4939 6.60324 0.292563 -9147 6 16.2694 6.84865 34.0054 -5.49782 1.82896 8.85162 -9148 4 16.5828 6.71308 33.1028 9.77351 -3.29618 -0.21352 -9149 4 16.9894 6.61948 34.6288 -2.86373 0.259786 -9.19674 -9150 6 33.6805 18.2019 10.4544 40.2358 -26.4835 -11.4715 -9151 4 34.2537 18.8203 9.96489 -9.74865 -7.15313 7.53482 -9152 4 34.2179 17.3378 10.5117 -27.819 38.8859 -1.78852 -9153 6 38.8962 33.7675 36.7566 23.6769 3.34821 -39.6603 -9154 4 38.383 33.5793 35.9171 9.63189 4.7017 21.543 -9155 4 39.855 33.8637 36.4612 -29.1237 -5.01255 9.39617 -9156 6 45.367 13.0954 20.2202 -17.4715 7.54819 27.7127 -9157 4 45.262 12.6289 19.4029 4.78427 -8.6457 -19.3619 -9158 4 44.4728 13.0498 20.6095 8.33403 2.77458 -3.46579 -9159 6 36.394 32.2025 8.83838 -5.39961 -0.779561 10.8196 -9160 4 36.3766 31.4559 9.45045 4.37642 -0.919546 -0.394048 -9161 4 35.9671 32.9207 9.33542 2.20851 -0.984819 -7.57369 -9162 6 7.93081 27.8143 6.16526 -1.31132 8.47671 -18.7581 -9163 4 8.2701 27.2941 6.88743 5.87236 -5.84072 6.56369 -9164 4 8.18271 28.7096 6.41539 -7.71007 1.94397 -1.55613 -9165 6 14.2797 4.87717 33.6823 -38.1616 11.9775 -32.0892 -9166 4 13.6477 5.2447 32.9846 23.9092 -16.4836 27.177 -9167 4 14.8408 5.63056 33.8658 12.4601 7.15131 6.13949 -9168 6 12.2578 8.65243 9.85848 -4.82715 -2.24662 -5.48477 -9169 4 12.6456 8.73928 10.7118 23.7259 9.48722 19.5525 -9170 4 11.4378 8.2214 10.089 -13.622 -8.47682 -13.9839 -9171 6 29.7261 31.9842 8.54243 -17.2145 25.3825 -18.7463 -9172 4 30.1804 31.833 9.34913 11.7892 -12.8324 21.9258 -9173 4 29.6399 31.1708 8.03663 5.85846 -6.51984 4.51241 -9174 6 22.3891 10.8785 21.4662 8.73739 -5.18702 6.55753 -9175 4 21.8037 11.1386 20.7714 -14.2177 0.338512 -24.4291 -9176 4 22.2091 11.5521 22.1168 2.36988 5.22793 14.1218 -9177 6 54.1797 27.5396 12.9955 26.3988 -18.3584 17.6139 -9178 4 0.160041 27.5787 13.0909 -6.71045 -5.06664 4.99497 -9179 4 53.9798 28.2721 12.4475 -15.7222 27.4826 -22.0497 -9180 6 7.71973 13.812 20.0407 -34.9077 17.0186 -30.9147 -9181 4 8.32362 14.1503 20.6766 20.1403 8.526 22.156 -9182 4 7.35968 14.6399 19.6101 8.73645 -26.5601 8.16532 -9183 6 19.7932 0.841243 24.7869 -1.21084 18.2021 12.2367 -9184 4 19.1669 1.06895 25.5104 7.86649 -0.445713 -11.3386 -9185 4 20.4073 1.61074 24.7031 -15.4775 -18.2332 3.4978 -9186 6 3.01312 10.0986 2.94829 -27.2997 12.089 -8.88269 -9187 4 2.52802 10.9508 2.83041 12.1807 -20.5661 3.67701 -9188 4 3.91304 10.3154 3.17839 17.025 6.36995 4.07131 -9189 6 15.8857 13.0124 24.0049 15.5529 -4.67501 -5.43243 -9190 4 15.0856 13.5308 24.0834 -5.13718 6.9751 3.63726 -9191 4 16.3233 13.139 24.8614 0.105722 -2.17465 -3.852 -9192 6 17.0852 4.33969 26.9167 21.5143 -4.09641 1.48348 -9193 4 16.9912 4.27513 25.9666 -0.355278 1.74978 -10.9716 -9194 4 18.0601 4.31538 27.0472 -16.9044 3.21714 1.83131 -9195 6 33.6168 39.4091 10.6433 -2.74936 14.5855 -32.8438 -9196 4 33.9454 38.5625 10.8616 8.60753 -33.4012 17.9817 -9197 4 33.8375 39.4354 9.68976 -8.01757 16.2593 11.171 -9198 6 36.2326 1.10755 13.0941 -10.1125 -3.31802 -5.56412 -9199 4 35.6506 0.392496 13.3579 -10.7819 -8.26966 -9.36682 -9200 4 36.7599 1.20112 13.8707 17.1874 9.72194 12.3054 -9201 6 40.862 19.2925 5.11158 -0.402197 -15.9333 44.5432 -9202 4 40.3871 19.4968 4.34679 -15.032 12.6888 -52.1674 -9203 4 40.1189 19.1611 5.72143 13.4548 0.976419 10.4775 -9204 6 2.35452 37.5497 10.1778 32.5589 0.132829 19.8916 -9205 4 3.04634 37.0953 10.7141 -10.4583 9.64478 -9.40166 -9206 4 1.85979 36.8581 9.75685 -15.4906 -16.9123 -13.0897 -9207 6 8.10293 29.0334 15.8847 29.3895 -23.7333 0.542295 -9208 4 9.03551 28.6824 15.7668 -29.6945 17.5799 0.572456 -9209 4 8.18484 29.8326 16.4072 3.85606 5.10463 3.42896 -9210 6 47.3132 26.514 12.5427 4.56821 28.1849 -37.0073 -9211 4 47.5111 27.2634 11.8891 -8.56493 -28.9528 31.2783 -9212 4 47.3519 25.7475 11.9556 -1.34676 -3.33794 4.54904 -9213 6 33.5886 17.4994 0.666432 -7.15301 -2.01744 8.51284 -9214 4 32.6196 17.5968 0.930917 31.8637 -19.8727 -7.43903 -9215 4 33.9404 16.5735 0.747207 -21.2256 15.6146 2.50609 -9216 6 38.9757 15.6004 36.3686 4.31005 -11.6982 -11.4703 -9217 4 39.1719 14.652 36.4294 -3.02079 4.3409 1.02949 -9218 4 39.3764 15.8813 35.5317 -1.53099 5.14915 -0.246696 -9219 6 34.8198 34.351 9.37266 2.46578 -22.7668 -16.8875 -9220 4 35.3506 35.0289 8.96724 14.9634 11.0695 -15.2613 -9221 4 34.4558 34.8191 10.0913 -19.5236 18.4179 34.8179 -9222 6 44.9681 2.58102 14.7874 21.8703 21.498 2.75759 -9223 4 44.0383 2.44896 14.9383 -16.9502 -5.72583 1.77575 -9224 4 45.1679 3.47323 15.1264 -3.49788 -5.23458 -3.46791 -9225 6 42.6138 38.2902 19.8325 18.6047 12.1973 -29.2276 -9226 4 42.7029 39.1598 19.3445 -0.0117609 -27.8329 13.7468 -9227 4 43.0921 37.6383 19.2425 -13.1736 20.1758 17.0781 -9228 6 18.6869 26.7647 30.2619 -33.6624 -6.012 -17.6355 -9229 4 18.1258 26.7596 29.445 14.3051 -0.674317 21.614 -9230 4 19.5687 26.9499 29.9621 19.5047 4.84041 -5.57389 -9231 6 38.8661 37.7421 16.4836 -9.78438 -6.51051 7.80135 -9232 4 38.7478 36.8102 16.2377 -7.01003 6.44463 1.75037 -9233 4 39.8105 37.8446 16.5724 18.1337 5.4462 2.51551 -9234 6 49.3017 9.82081 12.5377 12.9664 18.8416 30.0962 -9235 4 48.8085 9.39111 11.8826 -17.6666 -23.7062 -38.8329 -9236 4 48.5984 10.2345 13.0427 4.42646 9.01279 7.79627 -9237 6 43.2246 7.36268 19.8264 -1.99344 11.167 24.993 -9238 4 42.5572 7.81175 20.4051 12.7818 -10.9207 -14.0727 -9239 4 44.1025 7.51179 20.2375 -5.96789 -3.6213 -7.06723 -9240 6 36.3461 38.714 4.42821 -2.77728 9.11116 8.98737 -9241 4 36.8002 39.5234 4.70824 5.05063 -6.10698 -1.49424 -9242 4 35.4394 38.9016 4.68929 -3.84434 -7.68842 -3.54296 -9243 6 27.8 17.802 15.105 0.992317 -7.44098 -8.78046 -9244 4 27.5393 16.935 14.729 3.58787 16.6938 2.50389 -9245 4 27.8517 17.6781 16.0585 0.147204 -0.130556 3.13955 -9246 6 18.0837 3.77506 37.3201 -10.3169 -12.5791 -10.2966 -9247 4 18.6663 3.07474 37.0146 -2.03685 -5.25132 -4.70316 -9248 4 18.6637 4.19691 37.9324 10.4473 20.1285 21.3871 -9249 6 7.71395 11.575 6.52222 6.59834 -21.2687 20.1659 -9250 4 7.75955 12.4254 6.93969 -0.705235 13.257 9.50392 -9251 4 7.66936 11.739 5.5978 -3.42683 1.36071 -31.338 -9252 6 31.4909 14.3449 18.0451 -1.46982 -12.276 17.176 -9253 4 32.1287 14.6507 17.397 7.38292 5.65775 -7.44504 -9254 4 32.0331 13.8785 18.7146 -6.90734 4.25576 -5.30331 -9255 6 50.3346 30.4143 8.91505 10.1635 2.25064 -1.90936 -9256 4 49.6557 30.853 8.39615 -4.47176 4.28708 -1.87566 -9257 4 50.0231 29.531 9.11356 -2.73977 -1.84009 2.34474 -9258 6 42.1686 10.1057 12.759 16.2008 2.03437 -4.20809 -9259 4 41.2649 9.83209 12.6487 -17.4225 -8.81494 -4.74081 -9260 4 42.1292 10.8861 13.3105 -1.28453 5.18814 5.66853 -9261 6 37.773 3.09539 32.5582 -5.24906 4.78867 -2.39206 -9262 4 38.0736 3.99724 32.5969 21.7942 11.3719 -4.3192 -9263 4 36.8519 3.25822 32.7463 -19.4678 -11.9252 3.55114 -9264 6 35.7586 13.1005 19.2721 9.99017 -22.7528 0.0781354 -9265 4 36.1308 13.8223 19.7887 2.26592 2.2719 5.61144 -9266 4 36.2509 12.2915 19.5517 -9.66412 15.3645 -2.5809 -9267 6 45.5318 4.12684 21.4944 7.1153 -16.224 0.922187 -9268 4 45.5588 4.23252 20.5315 -1.8039 6.94223 3.67507 -9269 4 45.7548 3.18328 21.6122 -5.15542 13.2346 -0.821742 -9270 6 16.876 1.8608 31.4782 -3.84426 -17.9183 -35.0426 -9271 4 16.0621 2.17388 31.0004 15.6258 0.929179 27.3362 -9272 4 17.1381 2.25043 32.3174 -12.6393 14.1325 4.42374 -9273 6 14.0947 4.88307 23.5769 -10.6061 -28.6131 16.0669 -9274 4 13.8059 5.76888 23.7237 -2.25817 32.588 -6.82267 -9275 4 13.6039 4.42137 24.2892 9.04813 -2.88937 -11.9208 -9276 6 38.3208 33.7635 12.3625 -16.3318 -7.70706 -26.0192 -9277 4 38.1373 32.9408 11.8506 0.297782 14.7405 12.2413 -9278 4 39.1486 33.6221 12.8093 16.0136 -1.39994 11.7584 -9279 6 35.6849 3.05753 37.6719 3.72695 1.1389 -16.7638 -9280 4 35.1101 2.5063 38.212 -4.0587 0.687226 6.19097 -9281 4 35.8854 3.87289 38.1447 -1.86413 5.08658 8.8135 -9282 6 31.3385 37.395 35.3723 -12.2239 -8.91609 34.0312 -9283 4 32.2231 37.7249 35.5382 9.93962 6.70229 -3.55138 -9284 4 31.225 37.4524 34.4409 4.86335 0.993516 -31.3389 -9285 6 52.0614 11.7324 14.0182 20.1458 -4.7001 -39.6215 -9286 4 52.0268 11.0667 13.2735 0.495691 14.4049 24.809 -9287 4 52.7095 12.4171 13.7023 -24.8081 -17.2766 13.6147 -9288 6 26.3478 3.42613 41.0189 1.80794 1.58056 -19.374 -9289 4 25.6151 4.01507 40.9203 -25.7718 5.99951 16.8165 -9290 4 26.7914 3.68675 40.2055 22.5797 -12.3384 -0.204994 -9291 6 24.3802 34.9453 11.1613 28.8325 38.7039 -6.19962 -9292 4 24.3515 34.6784 12.0652 -4.50215 -14.1529 28.2178 -9293 4 23.9023 34.3202 10.6558 -20.492 -31.6724 -14.1682 -9294 6 32.0094 7.59293 31.2147 -3.26399 8.81733 5.62682 -9295 4 32.0976 7.47613 30.2777 2.1706 -0.778595 -17.1478 -9296 4 31.5266 8.43606 31.2858 0.565291 -7.84955 4.65821 -9297 6 28.7282 2.60805 0.424377 -15.1279 1.50585 -5.39222 -9298 4 29.2952 2.36387 41.5859 -5.33248 3.35197 5.42737 -9299 4 27.7901 2.65331 0.119401 23.4632 0.0509354 2.06419 -9300 6 42.125 19.2126 9.86039 10.7783 -7.26578 33.4177 -9301 4 42.6695 19.2101 10.7019 -20.1092 0.869002 -30.5597 -9302 4 41.4363 18.5278 9.96356 3.48727 6.10561 -4.25932 -9303 6 33.0194 27.0842 8.32851 16.6372 -6.55357 -10.7525 -9304 4 33.8911 27.0001 7.90493 -7.38323 -0.765342 -2.5624 -9305 4 33.2437 27.3744 9.20899 -0.425855 7.33259 11.2137 -9306 6 4.16433 8.30018 19.1575 16.0783 -2.51395 5.95143 -9307 4 4.71165 7.98099 18.3991 -19.3854 5.29846 8.38252 -9308 4 3.22273 8.32359 18.9288 3.05712 -5.28108 -12.2975 -9309 6 20.7745 29.1912 37.0609 -25.9123 -20.3491 -5.83769 -9310 4 21.0713 28.277 37.0594 -15.1664 -12.7508 0.5123 -9311 4 21.6013 29.5933 37.1743 32.957 35.4267 8.73191 -9312 6 13.1089 4.99809 10.9103 2.80775 13.1965 -7.17841 -9313 4 13.4591 5.85092 11.2415 -2.5949 -14.1267 -1.88178 -9314 4 12.7051 5.16456 10.0462 -1.2434 3.82389 2.90473 -9315 6 37.5087 18.1031 32.5343 20.0502 31.699 14.1692 -9316 4 38.1018 18.8164 32.1735 -18.2411 -21.7333 4.56216 -9317 4 37.2041 18.4813 33.3903 1.90105 -7.17599 -12.7275 -9318 6 17.7655 33.2839 30.7231 12.9967 19.9173 -17.9311 -9319 4 17.8488 34.0437 30.1253 -3.68331 -4.50715 1.49576 -9320 4 18.5638 33.345 31.2563 4.57995 -0.934488 4.72964 -9321 6 23.1969 32.7832 9.90135 2.14033 10.4984 -5.43395 -9322 4 23.4737 31.9362 10.2634 3.28964 -4.66398 1.33779 -9323 4 22.2469 32.7196 9.72631 0.753558 0.42269 -0.434072 -9324 6 14.8911 9.35828 34.246 -8.54616 0.784134 0.501674 -9325 4 15.4672 8.59016 34.1372 5.2294 -0.0873347 -3.8795 -9326 4 15.23 10.0905 33.7027 2.53244 -1.05206 0.202563 -9327 6 31.1203 39.3599 38.5719 4.30147 -17.578 8.21172 -9328 4 31.5941 38.6377 39.0527 -10.1026 17.4492 -9.05875 -9329 4 30.4019 38.9077 38.1077 1.84332 2.82409 1.03593 -9330 6 5.29005 34.4279 28.2716 -0.764315 -10.945 -9.90403 -9331 4 5.24266 35.3772 28.447 -0.427568 -2.02335 -2.15628 -9332 4 5.18384 34.3192 27.3143 2.05225 4.04935 9.99949 -9333 6 30.3216 21.6974 14.1256 3.24994 1.03129 -0.468005 -9334 4 30.4656 20.7696 14.235 0.884625 -14.9253 16.053 -9335 4 30.3519 21.7638 13.1772 -0.963709 16.3006 -15.7103 -9336 6 23.8542 39.0018 28.2919 38.6077 23.8437 -8.99828 -9337 4 23.8505 39.6937 27.6143 9.44649 3.56781 3.51793 -9338 4 23.0185 38.6309 28.1896 -50.029 -28.3524 0.952356 -9339 6 9.61332 13.5451 16.4567 13.7131 10.5156 -25.323 -9340 4 8.77595 13.0917 16.3907 -9.93448 -5.52821 8.41851 -9341 4 9.74204 13.8378 15.5322 5.69689 -3.544 12.5309 -9342 6 25.9753 6.18174 15.7989 23.4837 -9.67411 23.9067 -9343 4 26.0218 6.10484 14.8454 5.11216 -1.95092 -7.71856 -9344 4 26.7445 5.66727 16.1761 -27.6477 18.1551 -17.3833 -9345 6 15.9921 33.6419 22.5616 2.25497 8.86036 -26.9911 -9346 4 16.0049 34.0594 21.6804 -4.22455 0.568633 15.0409 -9347 4 16.1032 32.7157 22.281 -1.05219 8.42244 16.6761 -9348 6 40.6812 13.5416 12.1266 -4.5396 -12.3661 6.74099 -9349 4 40.4134 12.947 11.4149 -4.75912 -2.4644 -8.17888 -9350 4 41.058 12.9332 12.7776 -0.386087 8.79442 1.8157 -9351 6 35.5875 40.2809 31.6993 12.2791 -13.6127 -29.8257 -9352 4 35.948 40.913 31.0681 -4.17713 12.2213 7.17402 -9353 4 35.6271 39.4709 31.1475 -9.59473 3.36029 20.1077 -9354 6 19.3493 17.5927 17.849 24.123 48.8902 3.26857 -9355 4 19.9577 18.423 17.9915 -34.5112 -38.8316 -9.06029 -9356 4 18.6928 17.806 17.1645 6.15508 1.01267 5.31501 -9357 6 7.96541 28.082 10.7737 20.0283 17.3944 8.50509 -9358 4 8.43659 28.8341 11.2297 -13.1431 -15.7733 -11.3814 -9359 4 7.20109 28.4458 10.3015 -0.215648 4.06143 0.688545 -9360 6 32.1489 39.5869 16.6475 -7.37335 1.81146 -4.92627 -9361 4 31.705 40.4043 16.3332 3.90743 -15.5774 4.53996 -9362 4 31.4977 38.8659 16.5723 3.01217 10.596 3.08762 -9363 6 35.8095 2.63602 18.127 2.07542 -14.8225 4.13142 -9364 4 34.8947 2.32962 18.1713 7.15775 -3.6283 3.09768 -9365 4 35.7135 3.4873 17.7367 2.81673 20.5762 -11.5045 -9366 6 14.9588 39.9585 36.8943 -2.86001 -28.3727 24.0409 -9367 4 15.4545 39.4909 36.2335 10.0689 -8.68258 -13.459 -9368 4 15.0094 40.8569 36.655 2.72867 44.443 -9.08423 -9369 6 18.3115 32.3916 11.4639 8.59274 12.4423 14.7113 -9370 4 18.6438 32.5881 12.3772 -9.2478 -5.5834 -23.9484 -9371 4 17.8762 33.212 11.1576 6.35145 -13.5457 0.164794 -9372 6 14.605 10.3819 4.99774 5.57597 -6.68493 12.6773 -9373 4 13.677 10.4388 4.75284 -6.10435 1.24571 -3.75468 -9374 4 14.6185 10.047 5.91478 4.2493 4.0336 -10.9734 -9375 6 2.02851 14.3408 39.1627 -4.03313 12.5981 -1.48522 -9376 4 2.74992 15.009 39.2086 -14.5088 -8.45155 5.07373 -9377 4 1.21458 14.679 39.6124 19.1623 -3.42757 -8.41789 -9378 6 7.58709 14.1522 32.4651 10.4977 19.6861 -0.504887 -9379 4 6.93593 13.6605 32.9674 -3.57672 2.30039 3.8359 -9380 4 7.5987 15.0834 32.797 -1.90079 -22.9019 -5.87851 -9381 6 6.15309 23.123 37.664 -26.7168 -14.8188 -11.2926 -9382 4 6.52639 23.9838 37.7378 17.5333 20.6862 9.20416 -9383 4 5.45539 23.2608 36.9958 8.40974 -10.7335 8.81374 -9384 6 37.3009 22.5422 4.44282 21.6187 66.9857 0.670839 -9385 4 36.5208 22.1217 4.15693 -30.5217 -23.5005 -12.8181 -9386 4 37.1232 23.5227 4.23696 10.5274 -41.8214 11.62 -9387 6 47.1349 31.0113 5.88613 -14.3653 5.64202 -58.02 -9388 4 46.9542 30.9019 6.7933 -9.29323 -2.10558 39.1512 -9389 4 46.2627 31.2059 5.44524 20.5013 -7.22248 10.5418 -9390 6 54.8094 25.5909 34.9286 -5.37395 41.5808 12.672 -9391 4 54.0266 25.5089 35.4943 -0.981006 -11.4098 -6.26775 -9392 4 0.0616925 26.543 35.1263 -1.5494 -32.4448 -11.2369 -9393 6 37.1551 2.08197 4.79239 -12.5712 23.0197 -22.5278 -9394 4 36.5844 2.86136 4.61445 9.59981 -14.8952 -2.62483 -9395 4 37.0798 1.96202 5.72873 2.5296 -7.23911 19.6989 -9396 6 22.5239 28.6012 8.91155 -7.98869 19.6075 21.4366 -9397 4 22.8946 28.4124 9.79991 -0.853296 -5.89568 -17.4096 -9398 4 22.801 27.9767 8.25343 10.1708 -14.6558 -3.7409 -9399 6 8.64208 27.1509 24.5664 -38.2161 25.5543 4.78276 -9400 4 7.71753 26.8887 24.5582 -5.16372 11.0804 -0.386298 -9401 4 9.04357 26.3309 24.4724 40.7169 -47.477 -5.23592 -9402 6 1.14997 23.727 2.4309 6.46058 8.65979 -14.8341 -9403 4 1.18232 23.9936 1.48373 -6.63581 -4.99587 16.5657 -9404 4 0.310199 23.2733 2.54924 -0.981545 -0.950126 -1.89037 -9405 6 54.3702 30.2259 27.0243 -0.035121 6.58363 -4.50453 -9406 4 54.2615 29.4654 26.4339 1.23903 8.74071 -4.24792 -9407 4 54.6064 30.9974 26.4582 -3.83852 -12.4126 5.30421 -9408 6 0.386829 8.42023 23.9938 5.00922 -16.8445 -6.80376 -9409 4 1.36083 8.4508 24.0758 -8.17173 1.21512 3.08891 -9410 4 54.9524 8.88826 24.7258 9.13745 3.54566 6.13736 -9411 6 16.8971 28.5839 33.3722 23.8511 -30.9569 -4.46587 -9412 4 17.442 28.7831 34.1436 -6.82268 9.96305 3.46007 -9413 4 17.4403 27.8723 32.949 -23.4552 19.8179 6.40974 -9414 6 33.6969 30.8931 0.141175 14.1795 0.777253 -0.635822 -9415 4 34.6278 30.5945 0.162696 -6.8513 6.78484 1.91826 -9416 4 33.3211 30.3583 41.3463 -2.66034 -4.05802 -0.0970656 -9417 6 16.2525 21.5202 34.1552 3.2099 -15.0674 -0.387853 -9418 4 16.0099 20.7546 33.5903 4.90739 13.2878 5.87792 -9419 4 16.6977 21.1376 34.9376 -8.96682 7.2262 -10.6242 -9420 6 0.22977 17.7868 35.7492 -9.57638 -14.7124 1.37696 -9421 4 54.2434 17.9569 35.6827 28.6901 -4.22084 5.11773 -9422 4 0.351694 16.93 36.209 -4.1051 13.1178 -5.65765 -9423 6 16.8289 12.2962 0.019427 11.8958 12.8939 11.6481 -9424 4 17.3016 12.8498 0.703368 -12.3262 -21.137 -14.7379 -9425 4 16.4403 11.4936 0.411486 1.39397 8.07719 2.11333 -9426 6 8.24246 9.54397 36.2629 -25.8472 21.2414 2.40819 -9427 4 7.81464 8.9356 36.8788 1.26461 -2.06425 2.56422 -9428 4 7.48979 10.0869 35.9067 16.4576 -8.29365 1.86334 -9429 6 48.5761 26.718 39.8382 -16.8767 -13.2223 25.9758 -9430 4 48.2189 26.9037 38.9774 0.202946 6.43929 -15.4249 -9431 4 49.4865 26.9849 39.8847 17.129 6.93076 -9.10183 -9432 6 35.4777 1.07865 23.1156 20.3084 9.46551 28.8556 -9433 4 36.0215 1.72656 22.6213 -7.75205 -10.5654 8.45632 -9434 4 35.804 1.12911 24.09 -10.3378 -1.68949 -45.1242 -9435 6 20.2777 30.6326 19.3782 17.168 -16.4055 9.77372 -9436 4 20.2499 31.0311 20.2788 1.56461 -6.55175 -10.0354 -9437 4 20.938 29.881 19.3855 -20.6701 22.3694 2.2449 -9438 6 44.3702 15.9458 1.58361 10.9348 22.193 31.2112 -9439 4 44.4077 15.6379 2.51116 -1.71559 -1.42871 -18.164 -9440 4 44.6431 16.8967 1.66823 -9.97295 -22.8516 -13.6111 -9441 6 53.8845 34.4651 10.6068 -24.0145 7.95167 -19.3224 -9442 4 54.4361 34.2696 11.3314 22.7066 -9.19703 33.7305 -9443 4 54.2985 35.2035 10.1555 0.2437 -1.83103 1.50375 -9444 6 46.1364 32.8471 33.519 4.96533 -12.2334 2.48444 -9445 4 45.9404 33.6629 33.0556 -3.66306 8.73713 -2.86335 -9446 4 47.0477 32.6179 33.2654 -4.26196 1.19291 1.09329 -9447 6 42.1324 21.9098 24.2239 34.4777 -24.9191 34.4505 -9448 4 43.0412 21.5159 24.3646 -28.4667 14.3091 -11.1056 -9449 4 41.7437 21.6811 25.0949 -3.80951 9.2794 -19.6729 -9450 6 8.14185 3.89847 11.6387 2.30661 -15.3192 6.95264 -9451 4 7.35197 4.1174 12.1322 -8.99547 12.8437 -2.29886 -9452 4 8.35392 3.05748 12.0535 10.9023 -1.5691 -3.31016 -9453 6 19.6413 41.6808 9.8267 1.07442 6.29255 0.337359 -9454 4 18.9204 41.094 9.57509 0.414049 2.67892 1.92063 -9455 4 19.352 0.205183 10.6506 0.427822 -12.2572 -10.0953 -9456 6 42.3157 8.41085 31.6785 13.3628 11.5473 -7.23952 -9457 4 41.3969 8.42848 31.9417 -9.73605 -1.80426 0.915182 -9458 4 42.5534 9.35818 31.5624 -0.333442 -16.319 1.99913 -9459 6 26.911 16.154 25.3637 -0.10907 13.2502 -20.6653 -9460 4 26.7939 15.8861 24.4207 -0.565005 2.37017 21.4763 -9461 4 26.6835 15.4121 25.9182 -3.52016 -12.4926 6.14171 -9462 6 48.2345 6.48613 12.6212 -1.55264 -8.09911 -9.8466 -9463 4 48.9652 6.31914 12.0011 -5.93235 3.28214 2.19301 -9464 4 47.4516 6.10442 12.1764 7.36669 2.93589 5.65527 -9465 6 53.4556 41.5274 30.6561 0.928349 -3.66285 -10.4005 -9466 4 53.9738 41.8466 29.9077 -1.68735 -3.84443 -4.80087 -9467 4 53.7246 0.16796 31.3785 5.2081 5.34012 15.7103 -9468 6 47.0719 22.4215 31.8177 3.79963 28.0651 -15.4962 -9469 4 47.8542 22.5824 31.2379 -15.4047 -7.22606 14.7582 -9470 4 46.5391 23.2393 31.6689 5.43499 -22.2824 10.2038 -9471 6 19.5241 5.44646 15.2431 57.7261 9.00726 -25.1025 -9472 4 19.973 4.5781 15.2547 -6.4602 7.66804 1.10752 -9473 4 18.6769 5.33307 15.596 -47.9766 -8.78418 19.1468 -9474 6 14.6808 30.2445 33.392 16.954 11.9814 -17.0239 -9475 4 15.1668 30.8865 32.8123 -10.4914 -16.0898 10.6301 -9476 4 15.2553 29.4559 33.3904 -4.22445 9.80292 -0.52553 -9477 6 28.4427 24.2289 10.4187 -0.774793 -27.6212 -36.8967 -9478 4 29.277 24.4414 10.8128 10.21 14.4589 20.8069 -9479 4 27.7162 24.5027 10.9517 -9.91177 12.6254 22.5109 -9480 6 5.25429 14.4357 24.4952 18.8694 8.38265 -3.5804 -9481 4 4.38598 14.1455 24.6681 -43.369 -9.18674 12.4123 -9482 4 5.45154 13.9758 23.6794 9.52503 -2.95522 -10.1363 -9483 6 26.3476 19.2988 19.1857 11.4015 -18.2951 -12.5804 -9484 4 26.5417 20.1869 19.4853 3.52858 10.6793 1.31948 -9485 4 27.146 18.9308 18.7141 -21.2465 13.7562 17.259 -9486 6 28.5834 7.44603 13.1845 8.68409 29.8386 11.3246 -9487 4 28.3961 6.55455 12.9442 -2.45324 -19.0833 -9.20205 -9488 4 29.0571 7.89665 12.4686 -5.14786 -6.54739 -1.73865 -9489 6 5.35742 27.1473 37.0464 13.0843 -4.728 13.8292 -9490 4 6.09472 26.8663 37.6487 -17.7636 2.66278 -18.049 -9491 4 5.49884 28.0724 36.7882 1.93418 -3.90879 0.386893 -9492 6 53.1466 13.4128 16.1104 33.6732 -23.607 0.886679 -9493 4 54.0532 13.0537 15.8959 -24.4904 18.1541 2.55443 -9494 4 52.6056 12.6236 16.2807 -0.490038 10.6025 -2.0621 -9495 6 45.4595 1.03561 24.6152 0.883869 7.22473 8.82703 -9496 4 44.8005 0.912307 23.9218 -0.0838502 -1.3445 -1.23214 -9497 4 44.9845 0.757767 25.4168 6.19386 0.932014 -5.94613 -9498 6 50.1542 2.38642 13.9319 -2.4774 12.931 -1.3926 -9499 4 50.7815 2.76975 13.3044 0.014285 -4.08681 1.38242 -9500 4 49.5062 3.09016 14.0651 -1.63783 -0.639647 1.83323 -9501 6 19.5885 31.0175 39.1657 -10.9837 -21.6636 -18.6241 -9502 4 19.8079 30.3148 38.4832 -5.60324 21.7545 20.6111 -9503 4 18.6148 30.9453 39.3442 26.0441 2.6939 -5.02925 -9504 6 19.2491 14.7106 10.8907 20.9533 -11.5465 -13.087 -9505 4 20.0062 14.1954 10.4207 -44.2836 18.7066 28.5885 -9506 4 18.7045 14.0688 11.3882 14.1221 2.37282 -8.47947 -9507 6 4.44986 39.5549 20.1348 -7.46971 20.8744 22.4052 -9508 4 3.99116 40.4291 20.2667 12.3042 -22.0468 -4.08326 -9509 4 4.78876 39.261 21.0122 -11.398 5.88582 -21.7205 -9510 6 29.0264 13.3645 23.891 3.80322 20.0192 21.3715 -9511 4 28.7263 12.4558 23.8574 1.87437 -3.97007 -2.19356 -9512 4 28.9189 13.5991 24.8488 7.01015 0.856522 -27.3099 -9513 6 17.0674 2.76528 17.6511 13.6679 -9.88609 -24.0062 -9514 4 16.9089 3.43106 16.9566 -0.337692 -4.66999 2.92783 -9515 4 17.7694 2.16287 17.2836 -16.7881 13.7863 9.44417 -9516 6 43.472 18.0456 17.7207 2.90116 -6.00314 -10.3001 -9517 4 43.5328 17.0661 17.6262 0.602958 19.7978 9.46789 -9518 4 43.5843 18.2505 18.6627 0.176297 -8.32564 -1.3476 -9519 6 25.7838 40.7303 1.24723 -3.64329 26.5644 -28.0564 -9520 4 26.2198 41.3001 1.88369 1.46132 -2.86659 8.1156 -9521 4 25.5777 41.3986 0.532216 -2.57635 -28.6607 13.7824 -9522 6 0.458758 22.8928 6.22327 -2.28892 -3.37321 -2.62932 -9523 4 0.911995 22.0955 5.88137 -3.49653 6.37629 4.11618 -9524 4 1.15027 23.4262 6.63616 1.38998 -0.611711 -3.15133 -9525 6 26.2502 35.0072 18.629 11.2346 5.37396 -16.6635 -9526 4 25.9102 35.926 18.5821 -1.77201 -16.2127 4.61622 -9527 4 25.7094 34.5197 19.2578 -0.594129 4.22999 1.61862 -9528 6 16.1509 31.8837 7.54876 40.1408 -29.5169 -1.86921 -9529 4 16.9528 31.2446 7.38162 -38.5191 36.6879 6.5811 -9530 4 16.2422 32.6162 6.9246 8.25996 -4.45471 -3.71716 -9531 6 22.9569 16.8424 28.5503 -18.0144 15.9011 -12.9281 -9532 4 23.0242 16.0615 27.9964 2.65193 -8.47258 -0.731728 -9533 4 22.0914 17.2685 28.2981 23.9965 -14.5366 15.8079 -9534 6 48.817 29.3453 32.1483 10.2159 -3.67765 25.2301 -9535 4 47.913 29.23 31.8533 -10.4354 1.38436 -5.08298 -9536 4 48.8482 28.9579 33.0615 0.343667 8.53482 -20.1614 -9537 6 13.1275 24.857 5.54597 -15.7655 12.0094 -10.6158 -9538 4 12.8967 24.1126 4.95892 -3.19147 7.26676 2.83523 -9539 4 12.4206 25.5605 5.45199 17.9822 -22.1189 1.55356 -9540 6 10.967 20.7149 15.8389 3.49035 -8.57129 -4.90872 -9541 4 10.8232 20.5385 14.8814 6.84933 2.21154 19.4522 -9542 4 11.8211 20.2878 16.0966 -18.2767 7.30584 -13.8769 -9543 6 13.8574 18.376 6.9425 -18.5688 18.5302 -26.9748 -9544 4 14.0551 19.3329 6.99178 3.58444 -10.9562 5.12073 -9545 4 14.2751 17.8929 7.64202 12.8225 -6.30863 19.0643 -9546 6 13.8485 12.9413 30.6405 -7.33075 -24.1801 -9.47477 -9547 4 13.9233 12.3923 29.8469 14.5901 9.31788 -1.12157 -9548 4 13.0284 12.552 30.9634 -3.13873 11.8242 15.1361 -9549 6 17.1199 6.33729 31.2705 58.4108 60.4292 21.9502 -9550 4 16.7347 7.19592 31.0485 -2.55536 -2.82538 -1.05014 -9551 4 16.4932 5.72664 31.0455 -61.4006 -55.6776 -22.0804 -9552 6 7.63858 23.4232 20.5528 2.70849 -2.51933 -11.6338 -9553 4 7.34936 23.0623 19.6936 2.42656 1.66026 8.60009 -9554 4 8.06294 24.2698 20.3247 -2.54411 -7.58863 2.30144 -9555 6 15.6012 36.6828 25.6308 12.0382 0.865576 2.42327 -9556 4 16.546 36.4866 25.8589 -19.7129 13.5166 -7.57965 -9557 4 15.5566 37.5233 25.1245 15.7859 -9.47529 6.9914 -9558 6 0.738662 10.4099 22.1708 -26.6289 -22.4058 -14.7131 -9559 4 0.0268398 10.3645 21.4686 20.8647 0.21224 20.3485 -9560 4 0.555589 9.63254 22.7491 3.84168 18.0907 -12.5939 -9561 6 33.5034 17.3959 33.5951 21.201 30.6084 -13.4811 -9562 4 33.5895 18.3893 33.3705 0.776259 -45.1899 5.95193 -9563 4 34.1847 16.8766 33.1005 -9.04546 14.4589 8.38708 -9564 6 21.6622 19.013 20.7578 31.9274 -22.1518 -4.15649 -9565 4 22.4096 19.6032 20.9777 -11.5486 -3.71871 -1.82252 -9566 4 22.1307 18.1402 20.6082 -20.9219 25.304 3.1187 -9567 6 41.7583 19.992 16.8792 -6.68772 4.02339 -8.69865 -9568 4 42.2438 19.1637 16.9575 3.64207 -5.49479 0.617993 -9569 4 41.579 20.1273 15.9247 3.71595 -2.33609 11.0843 -9570 6 12.0355 14.9654 17.6922 -21.5841 1.26502 -18.8824 -9571 4 11.2182 14.5976 17.276 14.8021 5.3277 12.4216 -9572 4 12.4319 14.255 18.1907 -0.352973 -10.2116 7.98966 -9573 6 23.0172 11.4191 40.7206 -10.7217 24.0381 44.0704 -9574 4 22.9528 12.3236 41.1181 -0.480688 -24.3492 -4.33206 -9575 4 23.3445 11.5906 39.8675 15.3819 0.516123 -37.823 -9576 6 21.0055 28.3299 24.5595 -23.1154 26.0001 -7.02903 -9577 4 20.2855 28.1767 25.1713 -12.8069 16.7504 -3.2857 -9578 4 21.5564 27.6405 24.838 35.6802 -30.9994 4.41974 -9579 6 19.406 13.705 31.9364 14.5236 -8.57279 10.3452 -9580 4 18.7521 13.9469 31.2876 -5.81883 0.611034 -8.78432 -9581 4 18.9142 13.6788 32.7621 -0.186305 1.04404 6.29106 -9582 6 21.5918 2.86134 24.7058 -12.3779 12.1824 -8.79066 -9583 4 21.7274 3.16074 23.7816 9.4572 -7.89437 13.7797 -9584 4 22.4025 2.45534 25.0386 5.22934 2.42127 -4.70961 -9585 6 11.3487 29.9838 18.827 10.5554 -3.16976 4.47537 -9586 4 10.5352 30.5203 18.751 15.2364 -2.61973 2.60085 -9587 4 12.0043 30.4181 19.4217 -22.0541 -6.82347 -15.9561 -9588 6 14.6417 22.3529 8.3686 35.183 35.1516 7.4005 -9589 4 14.0314 23.0645 8.61446 -9.87113 -8.59651 0.991548 -9590 4 15.5117 22.8693 8.31218 -34.203 -30.7208 1.23805 -9591 6 43.9533 23.6664 17.2647 -9.15762 31.6597 -10.4885 -9592 4 44.7744 23.2846 16.9678 11.7125 -13.1472 -3.62648 -9593 4 43.5104 22.9908 17.7726 1.91474 -8.51607 6.21827 -9594 6 28.003 25.5014 27.4986 6.23457 -29.1533 -5.23677 -9595 4 27.4849 26.2827 27.5489 -17.6876 27.9136 1.36856 -9596 4 28.906 25.8001 27.3829 8.21911 6.89622 0.0845564 -9597 6 19.1046 26.8047 33.1413 12.2661 11.24 -48.0243 -9598 4 19.0365 26.4782 32.1917 1.11076 11.999 35.7369 -9599 4 19.4769 27.7251 33.0545 -9.7287 -23.6705 8.34301 -9600 6 6.37289 19.3428 5.67363 -3.21133 -16.2285 8.07537 -9601 4 6.7336 20.019 5.09886 3.22925 8.22387 -6.14542 -9602 4 5.58923 19.7346 6.08082 -0.796808 3.74051 2.3056 -9603 6 37.4835 28.3972 9.67963 -16.8252 8.64443 -22.9196 -9604 4 37.8384 28.0931 10.5154 1.79485 -10.7977 1.13655 -9605 4 37.3056 27.6421 9.07717 9.05958 5.47813 21.4583 -9606 6 17.6994 27.086 11.7957 -23.9049 -9.71644 -0.114793 -9607 4 16.9894 26.5877 11.2784 19.3807 18.9653 23.0761 -9608 4 17.3772 27.2467 12.7205 1.32974 -4.86863 -22.184 -9609 6 12.8804 1.95044 24.1635 -16.9081 23.6463 -41.3936 -9610 4 12.0123 2.42693 23.9788 24.6345 -20.1638 18.4271 -9611 4 12.9602 1.63912 25.0531 -11.2641 -4.9093 21.6908 -9612 6 27.8486 37.1249 33.3037 14.5525 0.843809 -12.8082 -9613 4 27.8306 37.7566 32.5563 -0.261378 -9.54721 11.1245 -9614 4 28.4641 36.389 33.0416 -14.495 18.5162 4.94281 -9615 6 18.6769 12.3657 6.31954 -0.243732 -29.9473 12.6257 -9616 4 18.5317 11.3932 6.23771 0.963018 17.4883 6.62231 -9617 4 18.5535 12.6707 5.42951 -3.51714 10.9469 -19.8301 -9618 6 10.1845 29.3127 24.783 -1.36331 5.89889 -4.08473 -9619 4 10.7465 29.1085 25.5662 -10.353 -5.60455 -9.55427 -9620 4 9.5047 28.6152 24.6271 17.6265 9.93184 12.3415 -9621 6 7.25219 3.30976 16.2618 16.5712 6.01323 38.0962 -9622 4 7.85224 3.92676 16.743 -7.28275 2.21025 -21.7569 -9623 4 7.07626 2.67339 16.9792 -0.839688 -3.96601 -21.0406 -9624 6 32.2032 37.556 1.10106 -1.45173 2.30566 -1.67736 -9625 4 31.7319 37.0242 1.72254 -12.3544 -30.6614 1.12887 -9626 4 32.1826 38.3533 1.61216 9.84976 31.1212 -1.90535 -9627 6 10.4132 10.1536 6.41547 2.6172 -5.66149 -5.23088 -9628 4 9.51094 10.4988 6.43252 -1.43241 7.72691 5.99088 -9629 4 10.888 10.4598 7.20926 -10.4429 3.02901 -4.20627 -9630 6 16.1922 23.2473 37.3836 13.4596 17.9231 -6.20094 -9631 4 16.4628 23.5362 38.2769 -1.8179 -2.41291 -6.91424 -9632 4 16.622 23.8878 36.7607 -9.68345 -13.0364 13.8052 -9633 6 24.0933 14.3373 36.5438 -0.810617 7.47513 6.008 -9634 4 25.0172 14.0983 36.6068 9.64822 -3.29568 0.232999 -9635 4 23.7283 14.0715 37.4031 -3.57511 2.15125 -3.19243 -9636 6 27.4694 18.5535 28.7878 -22.2405 -8.90967 9.68842 -9637 4 27.2463 18.155 29.6474 7.14424 4.94771 -10.1046 -9638 4 26.6163 18.5328 28.3045 10.7583 2.44378 -0.411902 -9639 6 51.5617 10.4928 1.56364 -46.044 -5.31617 -17.9438 -9640 4 50.711 10.1131 1.91707 23.1705 13.8427 -10.0979 -9641 4 52.2015 10.4284 2.24991 18.8641 -3.04547 25.194 -9642 6 31.1163 39.6073 27.5052 16.7753 -4.77526 -29.689 -9643 4 30.6203 39.2762 28.2489 -5.6675 10.9492 15.0474 -9644 4 31.3773 40.5466 27.6182 -8.67746 -20.5696 10.3555 -9645 6 6.90447 35.9666 14.3264 -30.1691 -4.34312 14.222 -9646 4 7.61578 36.3042 13.808 21.2575 5.14969 -9.00238 -9647 4 7.11482 35.0613 14.5906 3.01946 -0.973686 -2.74545 -9648 6 45.5514 7.57029 29.1841 -25.615 -5.69379 -2.02895 -9649 4 44.9198 7.51228 28.4263 15.6429 0.393509 16.1679 -9650 4 45.0848 7.11279 29.9186 7.09759 5.05324 -8.24334 -9651 6 31.3626 20.5603 31.6216 46.5235 7.85379 -13.5612 -9652 4 31.9622 21.3332 31.7077 -20.5518 -6.12612 6.97271 -9653 4 31.9328 19.9839 31.0823 -17.3109 -3.90007 7.28444 -9654 6 43.0286 31.1606 10.377 -16.6603 7.93207 28.9623 -9655 4 42.0878 30.8529 10.4887 24.119 8.07098 -2.29185 -9656 4 43.3099 31.4942 11.272 -6.72297 -13.7816 -28.1326 -9657 6 50.925 25.5606 12.6461 -27.6852 -6.08767 20.8539 -9658 4 50.917 26.3683 12.1731 -8.31821 35.0391 -16.2433 -9659 4 51.8024 25.2628 12.5325 34.7451 -18.8429 0.848912 -9660 6 29.3305 2.97987 3.64738 17.2649 -36.5424 -5.61333 -9661 4 29.6156 3.84373 3.86529 8.03017 35.8359 9.57326 -9662 4 28.4158 3.03535 3.41816 -23.9953 6.75187 -10.8335 -9663 6 53.9216 32.1051 20.3724 -11.2223 -0.478332 -4.16652 -9664 4 54.8523 32.157 20.1701 8.27859 1.2318 1.83366 -9665 4 53.5473 31.7256 19.5583 -4.88871 3.83013 8.11791 -9666 6 41.7036 29.5569 6.48267 17.2638 16.7804 -5.64052 -9667 4 40.7698 29.5903 6.27928 -11.16 5.83742 -3.44443 -9668 4 42.1548 30.305 5.99503 -16.5783 -19.3567 12.2041 -9669 6 37.8345 24.5719 39.3019 -13.0469 -9.65298 -3.86921 -9670 4 37.225 24.2046 38.6488 4.5791 4.74434 1.49749 -9671 4 37.4276 24.3068 40.1372 5.55374 4.45167 1.85829 -9672 6 46.5621 27.5658 23.2944 -23.9279 -33.0439 -11.1022 -9673 4 46.4387 27.4786 24.2739 -2.64996 -4.90603 -22.3791 -9674 4 45.938 26.8598 22.8442 32.7587 35.3455 32.269 -9675 6 9.23408 27.197 8.34767 -28.7607 6.82988 18.9345 -9676 4 8.89078 27.6282 9.16421 9.10203 -8.06063 -16.3167 -9677 4 10.1694 27.1106 8.44975 24.8451 0.83524 4.07321 -9678 6 36.0586 34.168 13.9947 0.546429 -20.5208 -0.995849 -9679 4 35.8317 33.2019 13.9926 1.47243 21.3574 0.844463 -9680 4 36.7518 34.2454 13.3214 -1.12661 -0.38848 2.20278 -9681 6 51.6812 14.492 12.3108 14.2062 7.57429 -10.7818 -9682 4 52.2015 14.4126 11.4771 -7.23407 7.45688 18.698 -9683 4 51.902 15.34 12.7416 -3.60656 -14.3916 -9.37264 -9684 6 15.248 19.6366 32.4109 27.4357 -16.6396 -20.9158 -9685 4 15.2931 19.2358 31.5053 -3.54534 7.22564 18.4797 -9686 4 14.3328 19.7639 32.5881 -28.0981 2.1384 2.91772 -9687 6 27.6849 24.6479 38.3573 2.41004 -14.3506 -18.7558 -9688 4 27.9256 25.2107 39.0738 -0.349992 17.1553 25.2623 -9689 4 28.4455 24.6938 37.7731 2.45273 -2.47407 -6.18841 -9690 6 37.5344 9.26205 13.6222 2.62805 -1.42602 2.92011 -9691 4 37.9029 8.73293 14.3466 0.897712 0.834078 0.0180659 -9692 4 37.323 10.115 14.0326 -0.799981 -1.44542 -1.10758 -9693 6 20.9013 33.2307 26.2512 6.46074 3.54373 3.40895 -9694 4 21.2661 33.4546 27.1222 -3.70394 5.03607 -5.2507 -9695 4 21.0534 32.294 26.1755 2.06129 -12.757 -1.69162 -9696 6 6.58179 13.9421 35.2385 -0.161437 -23.8226 2.06013 -9697 4 6.46846 12.9778 35.1898 -10.847 5.63462 -0.921172 -9698 4 7.53649 14.0007 35.2781 8.40152 11.229 1.63712 -9699 6 10.0736 7.47184 6.87074 6.29005 1.76204 -5.26249 -9700 4 9.16789 7.18556 6.66525 -0.124912 3.45645 -0.864518 -9701 4 10.1825 8.41968 6.63706 -5.90018 -13.0861 3.35766 -9702 6 31.1989 5.96627 11.4256 47.5137 28.7614 23.6553 -9703 4 31.4466 6.13876 12.388 -20.2952 -9.94335 -33.1747 -9704 4 32.0308 6.26994 10.9806 -22.1211 -12.2896 5.82222 -9705 6 12.1387 3.84993 35.2935 2.49551 -0.304387 23.4243 -9706 4 12.8187 4.19174 34.7257 10.4227 4.50872 -14.559 -9707 4 12.5185 4.00559 36.1769 -9.60543 -1.42105 -7.76228 -9708 6 5.33665 6.07757 27.6447 8.69228 -34.5823 40.5077 -9709 4 5.10952 6.83187 28.1919 -5.14709 12.9851 -0.252954 -9710 4 5.24124 6.31071 26.7545 -7.00092 22.4827 -45.3835 -9711 6 13.1372 33.5675 1.68451 12.1014 31.5323 -4.45098 -9712 4 12.5865 33.1501 1.03303 -8.81838 -7.47149 -8.20936 -9713 4 13.3352 34.4765 1.32576 -5.5291 -24.3721 14.4697 -9714 6 44.6567 10.4099 29.0319 -12.4525 3.56979 -21.9228 -9715 4 44.5737 9.45178 29.0051 9.95574 -3.72472 2.79876 -9716 4 44.0317 10.7133 28.332 10.7873 2.60441 13.9487 -9717 6 9.14585 24.5947 6.38022 15.9839 26.3438 -7.73853 -9718 4 8.92734 24.382 5.47582 -9.1117 -9.61509 -8.5024 -9719 4 9.72625 25.3768 6.21639 -5.50996 -10.1894 15.5503 -9720 6 52.5653 27.2618 21.6392 -6.48047 6.16108 13.4347 -9721 4 52.5564 26.3196 21.8908 4.78081 5.6644 -14.1528 -9722 4 52.8195 27.3969 20.7225 3.24319 -11.7343 -6.41363 -9723 6 7.29679 16.9603 33.544 -1.27463 2.76823 -11.9762 -9724 4 7.39152 17.7215 32.9493 2.03275 -0.910573 2.88066 -9725 4 6.37085 16.7082 33.4809 -4.66481 0.778096 -0.770576 -9726 6 43.9289 25.2227 7.97871 -4.96366 -10.0233 8.38699 -9727 4 43.2519 24.7308 8.49213 12.2574 5.67032 -8.3389 -9728 4 43.4276 25.9018 7.51862 -3.04483 5.5605 -3.23664 -9729 6 2.07953 27.1233 13.6028 0.0104954 7.16496 -8.77242 -9730 4 2.15896 26.2371 13.9627 -2.1358 -7.6126 6.04882 -9731 4 2.6502 27.1018 12.8141 -2.23666 2.89631 3.72058 -9732 6 37.3141 18.284 2.18477 -5.94753 -1.23785 7.60386 -9733 4 37.4961 17.5691 1.55591 -3.17432 -0.490531 -1.7774 -9734 4 36.7255 18.8979 1.7415 -3.03937 1.4219 -5.67571 -9735 6 25.0022 10.0655 0.429871 -30.1443 -7.37242 -0.593153 -9736 4 24.272 10.366 41.7528 14.2211 1.75124 5.05026 -9737 4 24.5705 9.40237 1.00583 14.7283 12.1051 -6.86513 diff --git a/examples/amoeba/in.ubiquitin b/examples/amoeba/in.ubiquitin index 8fb7f766a6..ccbcdec421 100644 --- a/examples/amoeba/in.ubiquitin +++ b/examples/amoeba/in.ubiquitin @@ -41,7 +41,7 @@ compute virial all pressure NULL virial thermo_style custom step temp epair ebond eangle edihed eimp & emol etotal press c_virial[*] -dump 1 all custom 10 dump.ubi id type x y z fx fy fz +dump 1 all custom 10 dump.ubiquitin id type x y z fx fy fz dump_modify 1 sort id # zero step run diff --git a/examples/amoeba/log.ubi.1 b/examples/amoeba/log.ubi.1 deleted file mode 100644 index f0c387e50b..0000000000 --- a/examples/amoeba/log.ubi.1 +++ /dev/null @@ -1,162 +0,0 @@ -LAMMPS (24 Mar 2022) -# solvated ubiquitin molecule with AMOEBA force field - -units real -boundary p p p -atom_modify sort 0 0.0 - -atom_style amoeba - -bond_style class2 -angle_style amoeba -dihedral_style fourier -improper_style amoeba - -# per-atom properties required by AMOEBA or HIPPO - -fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom i_amgroup d_redID d_pval ghost yes -fix extra2 all property/atom i_polaxe d2_xyzaxis 3 - -fix pit all amoeba/pitorsion -fix_modify pit energy yes -fix bit all amoeba/bitorsion bitorsion.ubiquitin.data -fix_modify bit energy yes - -# read data file - -read_data data.ubiquitin fix amtype NULL "Tinker Types" fix pit "pitorsion types" "PiTorsion Coeffs" fix pit pitorsions PiTorsions fix bit bitorsions BiTorsions -Reading data file ... - orthogonal box = (0 0 0) to (54.99 41.91 41.91) - 1 by 1 by 1 MPI processor grid - reading atoms ... - 9737 atoms - scanning bonds ... - 4 = max bonds/atom - scanning angles ... - 6 = max angles/atom - scanning dihedrals ... - 18 = max dihedrals/atom - scanning impropers ... - 3 = max impropers/atom - reading bonds ... - 6908 bonds - reading angles ... - 5094 angles - reading dihedrals ... - 3297 dihedrals - reading impropers ... - 651 impropers -Finding 1-2 1-3 1-4 neighbors ... - special bond factors lj: 0 0 0 - special bond factors coul: 0 0 0 - 4 = max # of 1-2 neighbors - 9 = max # of 1-3 neighbors - 19 = max # of 1-4 neighbors - 21 = max # of special neighbors - special bonds CPU = 0.004 seconds - read_data CPU = 0.082 seconds - -pair_style amoeba -pair_coeff * * amoeba_ubiquitin.prm amoeba_ubiquitin.key - -special_bonds lj/coul 0.5 0.5 0.5 one/five yes -Finding 1-2 1-3 1-4 neighbors ... - special bond factors lj: 0.5 0.5 0.5 - special bond factors coul: 0.5 0.5 0.5 - 4 = max # of 1-2 neighbors - 9 = max # of 1-3 neighbors - 19 = max # of 1-4 neighbors - 58 = max # of 1-5 neighbors - 21 = max # of special neighbors - special bonds CPU = 0.006 seconds - -# thermo output - -compute virial all pressure NULL virial - -thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] - -dump 1 all custom 10 dump.ubi id type x y z fx fy fz -dump_modify 1 sort id - -# zero step run - -#run 0 - -# dynamics - -fix 1 all nve - -thermo 1 -run 10 -AMOEBA/HIPPO force field settings - hal: cut 12 taper 10.8 vscale 0 0 1 1 - multipole: cut 7 aewald 0.4 bsorder 5 FFT 60 48 48 mscale 0 0 0.4 1 - polar: cut 7 aewald 0.5 bsorder 5 FFT 60 48 48 - pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 1 1 1 1 d/u scale 0 1 - precondition: cut 4.5 - generated 0 of 15 mixed pair_coeff terms from geometric mixing rule -Neighbor list info ... - update every 1 steps, delay 10 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 14 - ghost atom cutoff = 14 - binsize = 7, bins = 8 6 6 - 1 neighbor lists, perpetual/occasional/extra = 1 0 0 - (1) pair amoeba, perpetual - attributes: half, newton on - pair build: half/bin/newton - stencil: half/bin/3d - bin: standard - AMOEBA/HIPPO group count: 3196 -Per MPI rank memory allocation (min/avg/max) = 260.4 | 260.4 | 260.4 Mbytes - Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] - 0 0 -35338.057 2856.5938 1955.5431 224.37609 65.00809 5101.5211 -30247.585 -6336.5196 -5795.4272 -6329.8149 -6884.3167 349.52657 77.164877 652.41925 - 1 29.61379 -35356.153 2037.3541 1840.7883 223.90217 64.293945 4166.3385 -30341.522 -6486.773 -6452.8463 -6841.5982 -7386.1106 311.38025 120.72605 545.35513 - 2 78.518242 -35383.65 825.39919 1538.3909 222.55095 62.191009 2648.5321 -30467.814 -5502.9841 -6410.2998 -6396.1829 -6937.8137 217.3515 210.76948 294.28051 - 3 88.8921 -35402.11 938.99299 1162.2914 220.5271 58.832521 2380.644 -30453.516 -1929.5417 -3331.1291 -2769.7218 -3350.5733 117.32302 279.72705 31.237776 - 4 68.740402 -35477.589 2048.0659 858.03795 218.14277 54.460022 3178.7066 -30316.325 2041.1138 594.25938 1665.7799 1030.8539 66.230421 304.28296 -155.80224 - 5 76.267862 -35707.869 2206.6534 736.37385 215.75693 49.401674 3208.1859 -30299.377 2276.9276 536.21124 1893.4621 1258.492 92.097191 299.65604 -228.58369 - 6 118.24373 -36092.77 1166.179 815.59206 213.67399 44.022297 2239.4673 -30435.629 -1677.8051 -3988.2428 -2669.6848 -3247.7207 197.42472 285.87129 -162.35459 - 7 137.7204 -36521.444 782.87113 1026.745 212.04289 38.686259 2060.3452 -30479.082 -5987.83 -8386.8104 -7363.188 -7888.261 357.00835 253.66346 32.827786 - 8 112.66452 -36897.181 1750.0569 1269.152 210.83571 33.742799 3263.7874 -30379.432 -7886.4081 -9703.2601 -9043.015 -9555.2908 490.76046 182.31259 278.727 - 9 88.237359 -37209.906 2695.1766 1454.55 209.91331 29.503458 4389.1434 -30276.565 -8202.16 -9492.368 -9110.7037 -9639.2288 502.55699 107.82333 443.6705 - 10 108.86756 -37474.988 2240.4603 1523.7936 209.10313 26.208515 3999.5656 -30333.279 -8468.4347 -9956.923 -9709.5874 -10224.682 365.98214 95.262991 425.12746 -Loop time of 21.791 on 1 procs for 10 steps with 9737 atoms - -Performance: 0.040 ns/day, 605.307 hours/ns, 0.459 timesteps/s -99.1% CPU use with 1 MPI tasks x no OpenMP threads - -AMEOBA/HIPPO timing breakdown: - Init time: 0.0264311 0.00121566 - Hal time: 7.15654 32.9156 - Mpole time: 2.14232 9.85334 - Induce time: 7.99277 36.7617 - Polar time: 4.42403 20.3477 - Total time: 21.7421 - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 21.742 | 21.742 | 21.742 | 0.0 | 99.78 -Bond | 0.014806 | 0.014806 | 0.014806 | 0.0 | 0.07 -Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.0035774 | 0.0035774 | 0.0035774 | 0.0 | 0.02 -Output | 0.026947 | 0.026947 | 0.026947 | 0.0 | 0.12 -Modify | 0.0028419 | 0.0028419 | 0.0028419 | 0.0 | 0.01 -Other | | 0.0007034 | | | 0.00 - -Nlocal: 9737 ave 9737 max 9737 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Nghost: 31511 ave 31511 max 31511 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Neighs: 5.6393e+06 ave 5.6393e+06 max 5.6393e+06 min -Histogram: 1 0 0 0 0 0 0 0 0 0 - -Total # of neighbors = 5639296 -Ave neighs/atom = 579.16155 -Ave special neighs/atom = 3.1364897 -Neighbor list builds = 0 -Dangerous builds = 0 -Total wall time: 0:00:24 diff --git a/examples/amoeba/log.ubi.32 b/examples/amoeba/log.ubi.32 deleted file mode 100644 index b0bc4b381e..0000000000 --- a/examples/amoeba/log.ubi.32 +++ /dev/null @@ -1,162 +0,0 @@ -LAMMPS (24 Mar 2022) -# solvated ubiquitin molecule with AMOEBA force field - -units real -boundary p p p -atom_modify sort 0 0.0 - -atom_style amoeba - -bond_style class2 -angle_style amoeba -dihedral_style fourier -improper_style amoeba - -# per-atom properties required by AMOEBA or HIPPO - -fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom i_amgroup d_redID d_pval ghost yes -fix extra2 all property/atom i_polaxe d2_xyzaxis 3 - -fix pit all amoeba/pitorsion -fix_modify pit energy yes -fix bit all amoeba/bitorsion bitorsion.ubiquitin.data -fix_modify bit energy yes - -# read data file - -read_data data.ubiquitin fix amtype NULL "Tinker Types" fix pit "pitorsion types" "PiTorsion Coeffs" fix pit pitorsions PiTorsions fix bit bitorsions BiTorsions -Reading data file ... - orthogonal box = (0 0 0) to (54.99 41.91 41.91) - 4 by 2 by 4 MPI processor grid - reading atoms ... - 9737 atoms - scanning bonds ... - 4 = max bonds/atom - scanning angles ... - 6 = max angles/atom - scanning dihedrals ... - 18 = max dihedrals/atom - scanning impropers ... - 3 = max impropers/atom - reading bonds ... - 6908 bonds - reading angles ... - 5094 angles - reading dihedrals ... - 3297 dihedrals - reading impropers ... - 651 impropers -Finding 1-2 1-3 1-4 neighbors ... - special bond factors lj: 0 0 0 - special bond factors coul: 0 0 0 - 4 = max # of 1-2 neighbors - 9 = max # of 1-3 neighbors - 19 = max # of 1-4 neighbors - 21 = max # of special neighbors - special bonds CPU = 0.002 seconds - read_data CPU = 0.112 seconds - -pair_style amoeba -pair_coeff * * amoeba_ubiquitin.prm amoeba_ubiquitin.key - -special_bonds lj/coul 0.5 0.5 0.5 one/five yes -Finding 1-2 1-3 1-4 neighbors ... - special bond factors lj: 0.5 0.5 0.5 - special bond factors coul: 0.5 0.5 0.5 - 4 = max # of 1-2 neighbors - 9 = max # of 1-3 neighbors - 19 = max # of 1-4 neighbors - 58 = max # of 1-5 neighbors - 21 = max # of special neighbors - special bonds CPU = 0.002 seconds - -# thermo output - -compute virial all pressure NULL virial - -thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] - -dump 1 all custom 10 dump.ubi id type x y z fx fy fz -dump_modify 1 sort id - -# zero step run - -#run 0 - -# dynamics - -fix 1 all nve - -thermo 1 -run 10 -AMOEBA/HIPPO force field settings - hal: cut 12 taper 10.8 vscale 0 0 1 1 - multipole: cut 7 aewald 0.4 bsorder 5 FFT 60 48 48 mscale 0 0 0.4 1 - polar: cut 7 aewald 0.5 bsorder 5 FFT 60 48 48 - pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 1 1 1 1 d/u scale 0 1 - precondition: cut 4.5 - generated 0 of 15 mixed pair_coeff terms from geometric mixing rule -Neighbor list info ... - update every 1 steps, delay 10 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 14 - ghost atom cutoff = 14 - binsize = 7, bins = 8 6 6 - 1 neighbor lists, perpetual/occasional/extra = 1 0 0 - (1) pair amoeba, perpetual - attributes: half, newton on - pair build: half/bin/newton - stencil: half/bin/3d - bin: standard - AMOEBA/HIPPO group count: 3196 -Per MPI rank memory allocation (min/avg/max) = 73.46 | 73.76 | 74.86 Mbytes - Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] - 0 0 -35338.057 2856.5938 1955.5431 224.37609 65.00809 5101.5211 -30247.585 -6336.5196 -5795.4272 -6329.8149 -6884.3167 349.52657 77.164877 652.41925 - 1 29.61379 -35356.153 2037.3541 1840.7883 223.90217 64.293945 4166.3385 -30341.522 -6486.773 -6452.8463 -6841.5982 -7386.1106 311.38025 120.72605 545.35513 - 2 78.518242 -35383.65 825.39919 1538.3909 222.55095 62.191009 2648.5321 -30467.814 -5502.9841 -6410.2998 -6396.1829 -6937.8137 217.3515 210.76948 294.28051 - 3 88.8921 -35402.11 938.99299 1162.2914 220.5271 58.832521 2380.644 -30453.516 -1929.5417 -3331.1291 -2769.7218 -3350.5733 117.32302 279.72705 31.237776 - 4 68.740402 -35477.589 2048.0659 858.03795 218.14277 54.460022 3178.7066 -30316.325 2041.1138 594.25938 1665.7799 1030.8539 66.230421 304.28296 -155.80224 - 5 76.267862 -35707.869 2206.6534 736.37385 215.75693 49.401674 3208.1859 -30299.377 2276.9276 536.21124 1893.4621 1258.492 92.097191 299.65604 -228.58369 - 6 118.24373 -36092.77 1166.179 815.59206 213.67399 44.022297 2239.4673 -30435.629 -1677.8051 -3988.2428 -2669.6848 -3247.7207 197.42472 285.87129 -162.35459 - 7 137.7204 -36521.444 782.87113 1026.745 212.04289 38.686259 2060.3452 -30479.082 -5987.83 -8386.8104 -7363.188 -7888.261 357.00835 253.66346 32.827786 - 8 112.66452 -36897.181 1750.0569 1269.152 210.83571 33.742799 3263.7874 -30379.432 -7886.4081 -9703.2601 -9043.015 -9555.2908 490.76046 182.31259 278.727 - 9 88.237359 -37209.906 2695.1766 1454.55 209.91331 29.503458 4389.1434 -30276.565 -8202.16 -9492.368 -9110.7037 -9639.2288 502.55699 107.82333 443.6705 - 10 108.86756 -37474.988 2240.4603 1523.7936 209.10313 26.208515 3999.5656 -30333.279 -8468.4347 -9956.923 -9709.5874 -10224.682 365.98214 95.262991 425.12746 -Loop time of 1.51355 on 32 procs for 10 steps with 9737 atoms - -Performance: 0.571 ns/day, 42.043 hours/ns, 6.607 timesteps/s -99.5% CPU use with 32 MPI tasks x no OpenMP threads - -AMEOBA/HIPPO timing breakdown: - Init time: 0.0221241 0.0147382 - Hal time: 0.27487 18.3107 - Mpole time: 0.1964 13.0833 - Induce time: 0.743514 49.5298 - Polar time: 0.264231 17.602 - Total time: 1.50114 - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 1.5006 | 1.5014 | 1.5026 | 0.1 | 99.20 -Bond | 0.00023121 | 0.0006371 | 0.002095 | 0.0 | 0.04 -Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.0060146 | 0.008046 | 0.0092638 | 1.0 | 0.53 -Output | 0.0028415 | 0.0030424 | 0.003441 | 0.2 | 0.20 -Modify | 0.00011709 | 0.00019911 | 0.00036104 | 0.0 | 0.01 -Other | | 0.0002509 | | | 0.02 - -Nlocal: 304.281 ave 326 max 273 min -Histogram: 1 1 0 5 2 8 3 6 4 2 -Nghost: 7618.59 ave 7678 max 7545 min -Histogram: 1 1 4 4 5 5 2 2 4 4 -Neighs: 176228 ave 204476 max 149390 min -Histogram: 3 3 3 2 6 2 5 4 2 2 - -Total # of neighbors = 5639296 -Ave neighs/atom = 579.16155 -Ave special neighs/atom = 3.1364897 -Neighbor list builds = 0 -Dangerous builds = 0 -Total wall time: 0:00:01 diff --git a/examples/amoeba/log.water_box.amoeba.1 b/examples/amoeba/log.water_box.amoeba.1 deleted file mode 100644 index 8f81eaaf42..0000000000 --- a/examples/amoeba/log.water_box.amoeba.1 +++ /dev/null @@ -1,148 +0,0 @@ -LAMMPS (24 Mar 2022) -# water box with AMOEBA or HIPPO - -units real -boundary p p p - -atom_style amoeba -bond_style class2 -angle_style amoeba -dihedral_style none - -# per-atom properties required by AMOEBA or HIPPO - -fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom i_amgroup d_redID d_pval ghost yes -fix extra2 all property/atom i_polaxe d2_xyzaxis 3 - -# read data file - -read_data data.water_box.amoeba fix amtype NULL "Tinker Types" -Reading data file ... - orthogonal box = (0 0 0) to (18.643 18.643 18.643) - 1 by 1 by 1 MPI processor grid - reading atoms ... - 648 atoms - scanning bonds ... - 2 = max bonds/atom - scanning angles ... - 1 = max angles/atom - reading bonds ... - 432 bonds - reading angles ... - 216 angles -Finding 1-2 1-3 1-4 neighbors ... - special bond factors lj: 0 0 0 - special bond factors coul: 0 0 0 - 2 = max # of 1-2 neighbors - 1 = max # of 1-3 neighbors - 1 = max # of 1-4 neighbors - 2 = max # of special neighbors - special bonds CPU = 0.000 seconds - read_data CPU = 0.012 seconds - -# force field - -pair_style amoeba -pair_coeff * * amoeba_water.prm amoeba_water_box.key - -special_bonds lj/coul 0.5 0.5 0.5 one/five yes -Finding 1-2 1-3 1-4 neighbors ... - special bond factors lj: 0.5 0.5 0.5 - special bond factors coul: 0.5 0.5 0.5 - 2 = max # of 1-2 neighbors - 1 = max # of 1-3 neighbors - 1 = max # of 1-4 neighbors - 2 = max # of 1-5 neighbors - 2 = max # of special neighbors - special bonds CPU = 0.001 seconds - -# thermo output - -compute virial all pressure NULL virial - -thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] - -dump 1 all custom 10 dump.water_box id type x y z fx fy fz -dump_modify 1 sort id - -# zero step run - -#run 0 - -# dynamics - -fix 1 all nve - -thermo 10 -run 100 -AMOEBA/HIPPO force field settings - hal: cut 7 taper 6 vscale 0 0 1 1 - multipole: cut 7 aewald 0.4 bsorder 5 FFT 50 50 50 mscale 0 0 0.4 1 - polar: cut 7 aewald 0.5 bsorder 5 FFT 50 50 50 - pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 1 1 1 1 d/u scale 0 1 - precondition: cut 4.5 - generated 0 of 1 mixed pair_coeff terms from geometric mixing rule -Neighbor list info ... - update every 1 steps, delay 10 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 9 - ghost atom cutoff = 9 - binsize = 4.5, bins = 5 5 5 - 1 neighbor lists, perpetual/occasional/extra = 1 0 0 - (1) pair amoeba, perpetual - attributes: half, newton on - pair build: half/bin/newton - stencil: half/bin/3d - bin: standard - AMOEBA/HIPPO group count: 216 -Per MPI rank memory allocation (min/avg/max) = 58.28 | 58.28 | 58.28 Mbytes - Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] - 0 0 -2172.0441 166.82637 83.732524 0 0 250.5589 -1921.4852 -6181.7112 -4771.8292 -6955.3278 -6817.9765 -272.19746 3173.3487 2229.6526 - 10 105.50439 -2373.6865 136.67908 106.86552 0 0 243.54459 -1926.6678 -8441.2174 -10450.318 -9514.124 -9665.625 -301.45304 322.2435 1916.9694 - 20 143.90097 -2358.3516 70.951764 76.777106 0 0 147.72887 -1933.0976 -7370.463 -7728.4884 -11580.562 -8676.0017 -807.21546 780.4123 2096.7667 - 30 157.22768 -2375.4639 50.396281 87.108719 0 0 137.505 -1934.7321 -4449.9504 -6946.5881 -7865.3435 -4955.5443 -417.85139 -1004.0926 -36.630383 - 40 150.92709 -2354.1768 78.484257 53.799494 0 0 132.28375 -1930.8175 353.40845 -939.7978 -4636.1858 475.75837 -1074.4762 -1584.304 -574.27211 - 50 153.02614 -2388.7287 100.20124 65.814409 0 0 166.01565 -1927.5893 3975.1595 1366.008 426.2343 3887.1078 -1807.1658 -2534.8393 -2118.6912 - 60 155.01798 -2364.31 92.948309 44.252938 0 0 137.20125 -1928.1435 5793.7978 3521.2541 1421.9416 6110.7678 -1536.937 -2559.5674 -1502.2038 - 70 166.70629 -2383.4827 76.492455 55.020922 0 0 131.51338 -1930.4622 4743.9587 1916.6786 2839.9241 2670.7568 -169.67855 -187.58379 -2256.4529 - 80 171.82933 -2388.0347 76.463333 49.138785 0 0 125.60212 -1931.0453 2210.1222 -319.99043 330.98785 -394.25628 -44.858027 252.35533 -1985.0908 - 90 175.7327 -2423.7974 90.784969 63.725029 0 0 154.51 -1930.3722 -917.58179 -3941.9566 -2568.4278 -3415.3121 196.38051 2366.2885 -263.52434 - 100 173.73319 -2422.3616 99.761403 57.29505 0 0 157.05645 -1930.2461 -3586.4169 -5733.9943 -5881.4025 -6235.1905 -230.75166 959.02899 406.2349 -Loop time of 38.7603 on 1 procs for 100 steps with 648 atoms - -Performance: 0.223 ns/day, 107.668 hours/ns, 2.580 timesteps/s -99.6% CPU use with 1 MPI tasks x no OpenMP threads - -AMEOBA/HIPPO timing breakdown: - Init time: 0.0258209 0.000666708 - Hal time: 0.889324 2.29628 - Mpole time: 2.44816 6.32126 - Induce time: 29.4141 75.9487 - Polar time: 5.95145 15.3669 - Total time: 38.7289 - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 38.729 | 38.729 | 38.729 | 0.0 | 99.92 -Bond | 0.003226 | 0.003226 | 0.003226 | 0.0 | 0.01 -Neigh | 0.0054679 | 0.0054679 | 0.0054679 | 0.0 | 0.01 -Comm | 0.0036497 | 0.0036497 | 0.0036497 | 0.0 | 0.01 -Output | 0.01663 | 0.01663 | 0.01663 | 0.0 | 0.04 -Modify | 0.00088965 | 0.00088965 | 0.00088965 | 0.0 | 0.00 -Other | | 0.001155 | | | 0.00 - -Nlocal: 648 ave 648 max 648 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Nghost: 4290 ave 4290 max 4290 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Neighs: 98543 ave 98543 max 98543 min -Histogram: 1 0 0 0 0 0 0 0 0 0 - -Total # of neighbors = 98543 -Ave neighs/atom = 152.07253 -Ave special neighs/atom = 2 -Neighbor list builds = 2 -Dangerous builds = 0 -Total wall time: 0:00:39 diff --git a/examples/amoeba/log.water_box.amoeba.32 b/examples/amoeba/log.water_box.amoeba.32 deleted file mode 100644 index 16a0168dac..0000000000 --- a/examples/amoeba/log.water_box.amoeba.32 +++ /dev/null @@ -1,148 +0,0 @@ -LAMMPS (24 Mar 2022) -# water box with AMOEBA or HIPPO - -units real -boundary p p p - -atom_style amoeba -bond_style class2 -angle_style amoeba -dihedral_style none - -# per-atom properties required by AMOEBA or HIPPO - -fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom i_amgroup d_redID d_pval ghost yes -fix extra2 all property/atom i_polaxe d2_xyzaxis 3 - -# read data file - -read_data data.water_box.amoeba fix amtype NULL "Tinker Types" -Reading data file ... - orthogonal box = (0 0 0) to (18.643 18.643 18.643) - 2 by 4 by 4 MPI processor grid - reading atoms ... - 648 atoms - scanning bonds ... - 2 = max bonds/atom - scanning angles ... - 1 = max angles/atom - reading bonds ... - 432 bonds - reading angles ... - 216 angles -Finding 1-2 1-3 1-4 neighbors ... - special bond factors lj: 0 0 0 - special bond factors coul: 0 0 0 - 2 = max # of 1-2 neighbors - 1 = max # of 1-3 neighbors - 1 = max # of 1-4 neighbors - 2 = max # of special neighbors - special bonds CPU = 0.002 seconds - read_data CPU = 0.020 seconds - -# force field - -pair_style amoeba -pair_coeff * * amoeba_water.prm amoeba_water_box.key - -special_bonds lj/coul 0.5 0.5 0.5 one/five yes -Finding 1-2 1-3 1-4 neighbors ... - special bond factors lj: 0.5 0.5 0.5 - special bond factors coul: 0.5 0.5 0.5 - 2 = max # of 1-2 neighbors - 1 = max # of 1-3 neighbors - 1 = max # of 1-4 neighbors - 2 = max # of 1-5 neighbors - 2 = max # of special neighbors - special bonds CPU = 0.001 seconds - -# thermo output - -compute virial all pressure NULL virial - -thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] - -dump 1 all custom 10 dump.water_box id type x y z fx fy fz -dump_modify 1 sort id - -# zero step run - -#run 0 - -# dynamics - -fix 1 all nve - -thermo 10 -run 100 -AMOEBA/HIPPO force field settings - hal: cut 7 taper 6 vscale 0 0 1 1 - multipole: cut 7 aewald 0.4 bsorder 5 FFT 50 50 50 mscale 0 0 0.4 1 - polar: cut 7 aewald 0.5 bsorder 5 FFT 50 50 50 - pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 1 1 1 1 d/u scale 0 1 - precondition: cut 4.5 - generated 0 of 1 mixed pair_coeff terms from geometric mixing rule -Neighbor list info ... - update every 1 steps, delay 10 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 9 - ghost atom cutoff = 9 - binsize = 4.5, bins = 5 5 5 - 1 neighbor lists, perpetual/occasional/extra = 1 0 0 - (1) pair amoeba, perpetual - attributes: half, newton on - pair build: half/bin/newton - stencil: half/bin/3d - bin: standard - AMOEBA/HIPPO group count: 216 -Per MPI rank memory allocation (min/avg/max) = 57.47 | 57.48 | 57.74 Mbytes - Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] - 0 0 -2172.0441 166.82637 83.732524 0 0 250.5589 -1921.4852 -6181.7112 -4771.8292 -6955.3278 -6817.9765 -272.19746 3173.3487 2229.6526 - 10 105.50439 -2373.6865 136.67908 106.86552 0 0 243.54459 -1926.6678 -8441.2174 -10450.318 -9514.124 -9665.625 -301.45304 322.2435 1916.9694 - 20 143.90097 -2358.3516 70.951764 76.777106 0 0 147.72887 -1933.0976 -7370.463 -7728.4884 -11580.562 -8676.0017 -807.21546 780.4123 2096.7667 - 30 157.22768 -2375.4639 50.396281 87.108719 0 0 137.505 -1934.7321 -4449.9504 -6946.5881 -7865.3435 -4955.5443 -417.85139 -1004.0926 -36.630383 - 40 150.92709 -2354.1768 78.484257 53.799494 0 0 132.28375 -1930.8175 353.40845 -939.7978 -4636.1858 475.75837 -1074.4762 -1584.304 -574.27211 - 50 153.02614 -2388.7287 100.20124 65.814409 0 0 166.01565 -1927.5893 3975.1595 1366.008 426.2343 3887.1078 -1807.1658 -2534.8393 -2118.6912 - 60 155.01798 -2364.31 92.948309 44.252938 0 0 137.20125 -1928.1435 5793.7978 3521.2541 1421.9416 6110.7678 -1536.937 -2559.5674 -1502.2038 - 70 166.70629 -2383.4827 76.492455 55.020922 0 0 131.51338 -1930.4622 4743.9587 1916.6786 2839.9241 2670.7568 -169.67855 -187.58379 -2256.4529 - 80 171.82933 -2388.0347 76.463333 49.138785 0 0 125.60212 -1931.0453 2210.1222 -319.99043 330.98785 -394.25628 -44.858027 252.35533 -1985.0908 - 90 175.7327 -2423.7974 90.784969 63.725029 0 0 154.51 -1930.3722 -917.58179 -3941.9566 -2568.4278 -3415.3121 196.38051 2366.2885 -263.52434 - 100 173.73319 -2422.3616 99.761403 57.29505 0 0 157.05645 -1930.2461 -3586.4169 -5733.9943 -5881.4025 -6235.1905 -230.75166 959.02899 406.2349 -Loop time of 6.48935 on 32 procs for 100 steps with 648 atoms - -Performance: 1.331 ns/day, 18.026 hours/ns, 15.410 timesteps/s -99.8% CPU use with 32 MPI tasks x no OpenMP threads - -AMEOBA/HIPPO timing breakdown: - Init time: 0.0357484 0.00553355 - Hal time: 0.0364815 0.564704 - Mpole time: 0.541384 8.38018 - Induce time: 4.89091 75.7073 - Polar time: 0.955739 14.794 - Total time: 6.46029 - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 6.4536 | 6.4614 | 6.4698 | 0.2 | 99.57 -Bond | 0.00025488 | 0.00038243 | 0.00051904 | 0.0 | 0.01 -Neigh | 0.00033789 | 0.00036365 | 0.00040331 | 0.0 | 0.01 -Comm | 0.013439 | 0.021894 | 0.02956 | 2.9 | 0.34 -Output | 0.0038126 | 0.0038325 | 0.0040712 | 0.1 | 0.06 -Modify | 0.00021256 | 0.00028049 | 0.00035212 | 0.0 | 0.00 -Other | | 0.001189 | | | 0.02 - -Nlocal: 20.25 ave 26 max 12 min -Histogram: 1 1 3 1 2 7 3 11 1 2 -Nghost: 1381.97 ave 1413 max 1354 min -Histogram: 3 5 4 0 6 3 1 4 5 1 -Neighs: 3079.47 ave 4080 max 1858 min -Histogram: 1 3 1 2 5 6 7 5 0 2 - -Total # of neighbors = 98543 -Ave neighs/atom = 152.07253 -Ave special neighs/atom = 2 -Neighbor list builds = 2 -Dangerous builds = 0 -Total wall time: 0:00:06 diff --git a/examples/amoeba/log.water_box.hippo.1 b/examples/amoeba/log.water_box.hippo.1 deleted file mode 100644 index ffac98ae05..0000000000 --- a/examples/amoeba/log.water_box.hippo.1 +++ /dev/null @@ -1,152 +0,0 @@ -LAMMPS (24 Mar 2022) -# water box with AMOEBA or HIPPO - -units real -boundary p p p - -atom_style amoeba -bond_style class2 -angle_style amoeba -dihedral_style none - -# per-atom properties required by AMOEBA or HIPPO - -fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom i_amgroup d_redID d_pval ghost yes -fix extra2 all property/atom i_polaxe d2_xyzaxis 3 - -# read data file - -read_data data.water_box.hippo fix amtype NULL "Tinker Types" -Reading data file ... - orthogonal box = (0 0 0) to (18.643 18.643 18.643) - 1 by 1 by 1 MPI processor grid - reading atoms ... - 648 atoms - scanning bonds ... - 2 = max bonds/atom - scanning angles ... - 1 = max angles/atom - reading bonds ... - 432 bonds - reading angles ... - 216 angles -Finding 1-2 1-3 1-4 neighbors ... - special bond factors lj: 0 0 0 - special bond factors coul: 0 0 0 - 2 = max # of 1-2 neighbors - 1 = max # of 1-3 neighbors - 1 = max # of 1-4 neighbors - 2 = max # of special neighbors - special bonds CPU = 0.000 seconds - read_data CPU = 0.012 seconds - -# force field - -pair_style hippo -pair_coeff * * hippo_water.prm hippo_water_box.key - -special_bonds lj/coul 0.5 0.5 0.5 one/five yes -Finding 1-2 1-3 1-4 neighbors ... - special bond factors lj: 0.5 0.5 0.5 - special bond factors coul: 0.5 0.5 0.5 - 2 = max # of 1-2 neighbors - 1 = max # of 1-3 neighbors - 1 = max # of 1-4 neighbors - 2 = max # of 1-5 neighbors - 2 = max # of special neighbors - special bonds CPU = 0.001 seconds - -# thermo output - -compute virial all pressure NULL virial - -thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] - -dump 1 all custom 10 dump.water_box id type x y z fx fy fz -dump_modify 1 sort id - -# zero step run - -#run 0 - -# dynamics - -fix 1 all nve - -thermo 10 -run 100 -AMOEBA/HIPPO force field settings - repulsion: cut 7 taper 6 rscale 0 0 1 1 - qxfer: cut 7 taper 6 mscale 0 0 0.4 1 - dispersion: cut 7 aewald 0.45 bsorder 4 FFT 16 16 16 dspscale 0 0 0.4 1 - multipole: cut 7 aewald 0.4 bsorder 5 FFT 24 24 24 mscale 0 0 0.4 1 - polar: cut 7 aewald 0.5 bsorder 5 FFT 24 24 24 - pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 0.2 1 1 1 d/u scale 0 1 - precondition: cut 4.5 - generated 0 of 1 mixed pair_coeff terms from geometric mixing rule -Neighbor list info ... - update every 1 steps, delay 10 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 9 - ghost atom cutoff = 9 - binsize = 4.5, bins = 5 5 5 - 1 neighbor lists, perpetual/occasional/extra = 1 0 0 - (1) pair hippo, perpetual - attributes: half, newton on - pair build: half/bin/newton - stencil: half/bin/3d - bin: standard - AMOEBA/HIPPO group count: 216 -Per MPI rank memory allocation (min/avg/max) = 57.8 | 57.8 | 57.8 Mbytes - Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] - 0 0 -2188.594 166.82637 77.478353 0 0 244.30473 -1944.2893 -10859.589 -9285.4645 -11598.049 -11695.254 -282.7072 3164.4148 2495.2578 - 10 100.94691 -2350.192 116.13156 88.56605 0 0 204.69761 -1950.8098 -11480.919 -13574.139 -12190.797 -12798.212 -263.77028 280.62864 1974.1486 - 20 153.91622 -2358.3058 36.396961 66.22466 0 0 102.62162 -1958.8438 -7778.4529 -8492.3868 -11999.431 -9125.9998 -917.99962 589.09064 1788.2094 - 30 145.5951 -2343.9956 39.651541 65.833248 0 0 105.48479 -1957.7184 -288.79965 -2574.4466 -3820.4824 -414.28285 -347.51491 -1147.3995 -126.71025 - 40 126.87801 -2340.2623 102.93951 43.896946 0 0 146.83646 -1948.7309 6766.15 5908.7048 1280.0961 7930.8191 -1085.6811 -1596.6859 -714.82888 - 50 134.52078 -2358.9232 107.49288 44.253826 0 0 151.74671 -1947.7419 8762.4348 6023.4661 5377.0189 9396.0316 -1629.1364 -1663.1666 -2381.51 - 60 173.10181 -2374.3854 51.097314 33.03646 0 0 84.133774 -1956.4102 4614.2907 1719.1989 505.79149 4552.3167 -1661.1714 -587.92108 -1380.6732 - 70 184.86849 -2391.6106 39.916931 35.978152 0 0 75.895083 -1959.1811 -2146.9339 -4993.4021 -4095.6729 -4897.5768 -833.09046 1542.411 -1539.5266 - 80 164.75795 -2406.3017 101.94229 33.067832 0 0 135.01013 -1953.542 -8779.3265 -10545.409 -10418.702 -12098.858 -1319.194 1750.3511 -275.1272 - 90 151.17491 -2434.6876 152.21826 41.301673 0 0 193.51993 -1949.6141 -13330.691 -15436.505 -13791.461 -16934.674 149.25497 2289.1026 976.14333 - 100 166.99163 -2452.5298 143.57768 35.341459 0 0 178.91914 -1951.5533 -14918.51 -16077.49 -17353.738 -18140.466 19.009088 1487.0469 1084.0231 -Loop time of 9.27469 on 1 procs for 100 steps with 648 atoms - -Performance: 0.932 ns/day, 25.763 hours/ns, 10.782 timesteps/s -99.0% CPU use with 1 MPI tasks x no OpenMP threads - -AMEOBA/HIPPO timing breakdown: - Init time: 0.012403 0.00134127 - Repulse time: 1.04474 11.2979 - Disp time: 0.83125 8.98919 - Mpole time: 1.66803 18.0382 - Induce time: 3.2846 35.5199 - Polar time: 2.12371 22.9659 - Qxfer time: 0.282486 3.05482 - Total time: 9.24722 - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 9.2473 | 9.2473 | 9.2473 | 0.0 | 99.70 -Bond | 0.0023727 | 0.0023727 | 0.0023727 | 0.0 | 0.03 -Neigh | 0.0055338 | 0.0055338 | 0.0055338 | 0.0 | 0.06 -Comm | 0.0021428 | 0.0021428 | 0.0021428 | 0.0 | 0.02 -Output | 0.016044 | 0.016044 | 0.016044 | 0.0 | 0.17 -Modify | 0.00059122 | 0.00059122 | 0.00059122 | 0.0 | 0.01 -Other | | 0.0006893 | | | 0.01 - -Nlocal: 648 ave 648 max 648 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Nghost: 4282 ave 4282 max 4282 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Neighs: 98490 ave 98490 max 98490 min -Histogram: 1 0 0 0 0 0 0 0 0 0 - -Total # of neighbors = 98490 -Ave neighs/atom = 151.99074 -Ave special neighs/atom = 2 -Neighbor list builds = 2 -Dangerous builds = 0 -Total wall time: 0:00:09 diff --git a/examples/amoeba/log.water_box.hippo.32 b/examples/amoeba/log.water_box.hippo.32 deleted file mode 100644 index 5bf59135a6..0000000000 --- a/examples/amoeba/log.water_box.hippo.32 +++ /dev/null @@ -1,152 +0,0 @@ -LAMMPS (24 Mar 2022) -# water box with AMOEBA or HIPPO - -units real -boundary p p p - -atom_style amoeba -bond_style class2 -angle_style amoeba -dihedral_style none - -# per-atom properties required by AMOEBA or HIPPO - -fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom i_amgroup d_redID d_pval ghost yes -fix extra2 all property/atom i_polaxe d2_xyzaxis 3 - -# read data file - -read_data data.water_box.hippo fix amtype NULL "Tinker Types" -Reading data file ... - orthogonal box = (0 0 0) to (18.643 18.643 18.643) - 2 by 4 by 4 MPI processor grid - reading atoms ... - 648 atoms - scanning bonds ... - 2 = max bonds/atom - scanning angles ... - 1 = max angles/atom - reading bonds ... - 432 bonds - reading angles ... - 216 angles -Finding 1-2 1-3 1-4 neighbors ... - special bond factors lj: 0 0 0 - special bond factors coul: 0 0 0 - 2 = max # of 1-2 neighbors - 1 = max # of 1-3 neighbors - 1 = max # of 1-4 neighbors - 2 = max # of special neighbors - special bonds CPU = 0.002 seconds - read_data CPU = 0.020 seconds - -# force field - -pair_style hippo -pair_coeff * * hippo_water.prm hippo_water_box.key - -special_bonds lj/coul 0.5 0.5 0.5 one/five yes -Finding 1-2 1-3 1-4 neighbors ... - special bond factors lj: 0.5 0.5 0.5 - special bond factors coul: 0.5 0.5 0.5 - 2 = max # of 1-2 neighbors - 1 = max # of 1-3 neighbors - 1 = max # of 1-4 neighbors - 2 = max # of 1-5 neighbors - 2 = max # of special neighbors - special bonds CPU = 0.002 seconds - -# thermo output - -compute virial all pressure NULL virial - -thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] - -dump 1 all custom 10 dump.water_box id type x y z fx fy fz -dump_modify 1 sort id - -# zero step run - -#run 0 - -# dynamics - -fix 1 all nve - -thermo 10 -run 100 -AMOEBA/HIPPO force field settings - repulsion: cut 7 taper 6 rscale 0 0 1 1 - qxfer: cut 7 taper 6 mscale 0 0 0.4 1 - dispersion: cut 7 aewald 0.45 bsorder 4 FFT 16 16 16 dspscale 0 0 0.4 1 - multipole: cut 7 aewald 0.4 bsorder 5 FFT 24 24 24 mscale 0 0 0.4 1 - polar: cut 7 aewald 0.5 bsorder 5 FFT 24 24 24 - pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 0.2 1 1 1 d/u scale 0 1 - precondition: cut 4.5 - generated 0 of 1 mixed pair_coeff terms from geometric mixing rule -Neighbor list info ... - update every 1 steps, delay 10 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 9 - ghost atom cutoff = 9 - binsize = 4.5, bins = 5 5 5 - 1 neighbor lists, perpetual/occasional/extra = 1 0 0 - (1) pair hippo, perpetual - attributes: half, newton on - pair build: half/bin/newton - stencil: half/bin/3d - bin: standard - AMOEBA/HIPPO group count: 216 -Per MPI rank memory allocation (min/avg/max) = 57.03 | 57.04 | 57.3 Mbytes - Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] - 0 0 -2188.594 166.82637 77.478353 0 0 244.30473 -1944.2893 -10859.589 -9285.4645 -11598.049 -11695.254 -282.7072 3164.4148 2495.2578 - 10 100.94691 -2350.192 116.13156 88.56605 0 0 204.69761 -1950.8098 -11480.919 -13574.139 -12190.797 -12798.212 -263.77028 280.62864 1974.1486 - 20 153.91622 -2358.3058 36.396961 66.22466 0 0 102.62162 -1958.8438 -7778.4529 -8492.3868 -11999.431 -9125.9998 -917.99962 589.09064 1788.2094 - 30 145.5951 -2343.9956 39.651541 65.833248 0 0 105.48479 -1957.7184 -288.79965 -2574.4466 -3820.4824 -414.28285 -347.51491 -1147.3995 -126.71025 - 40 126.87801 -2340.2623 102.93951 43.896946 0 0 146.83646 -1948.7309 6766.15 5908.7048 1280.0961 7930.8191 -1085.6811 -1596.6859 -714.82888 - 50 134.52078 -2358.9232 107.49288 44.253826 0 0 151.74671 -1947.7419 8762.4348 6023.4661 5377.0189 9396.0316 -1629.1364 -1663.1666 -2381.51 - 60 173.10181 -2374.3854 51.097314 33.03646 0 0 84.133774 -1956.4102 4614.2907 1719.1989 505.79149 4552.3167 -1661.1714 -587.92108 -1380.6732 - 70 184.86849 -2391.6106 39.916931 35.978152 0 0 75.895083 -1959.1811 -2146.9339 -4993.4021 -4095.6729 -4897.5768 -833.09046 1542.411 -1539.5266 - 80 164.75795 -2406.3017 101.94229 33.067832 0 0 135.01013 -1953.542 -8779.3265 -10545.409 -10418.702 -12098.858 -1319.194 1750.3511 -275.1272 - 90 151.17491 -2434.6876 152.21826 41.301673 0 0 193.51993 -1949.6141 -13330.691 -15436.505 -13791.461 -16934.674 149.25497 2289.1026 976.14333 - 100 166.99163 -2452.5298 143.57768 35.341459 0 0 178.91914 -1951.5533 -14918.51 -16077.49 -17353.738 -18140.466 19.009088 1487.0469 1084.0231 -Loop time of 1.60312 on 32 procs for 100 steps with 648 atoms - -Performance: 5.389 ns/day, 4.453 hours/ns, 62.378 timesteps/s -99.8% CPU use with 32 MPI tasks x no OpenMP threads - -AMEOBA/HIPPO timing breakdown: - Init time: 0.019742 0.012493 - Repulse time: 0.0675395 4.27399 - Disp time: 0.142632 9.02596 - Mpole time: 0.265051 16.7728 - Induce time: 0.740525 46.8614 - Polar time: 0.332551 21.0442 - Qxfer time: 0.0121995 0.772001 - Total time: 1.58025 - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 1.5773 | 1.5814 | 1.5855 | 0.2 | 98.65 -Bond | 0.00015755 | 0.00023663 | 0.0003199 | 0.0 | 0.01 -Neigh | 0.00036065 | 0.00038248 | 0.00042908 | 0.0 | 0.02 -Comm | 0.01209 | 0.016226 | 0.020477 | 1.7 | 1.01 -Output | 0.0037797 | 0.0038027 | 0.0040217 | 0.1 | 0.24 -Modify | 0.00010094 | 0.00013624 | 0.00018983 | 0.0 | 0.01 -Other | | 0.0008996 | | | 0.06 - -Nlocal: 20.25 ave 27 max 12 min -Histogram: 1 1 3 1 6 2 10 4 2 2 -Nghost: 1379.75 ave 1408 max 1345 min -Histogram: 2 4 1 3 3 4 4 3 2 6 -Neighs: 3077.81 ave 4233 max 1858 min -Histogram: 1 3 1 4 5 7 6 2 1 2 - -Total # of neighbors = 98490 -Ave neighs/atom = 151.99074 -Ave special neighs/atom = 2 -Neighbor list builds = 2 -Dangerous builds = 0 -Total wall time: 0:00:01 diff --git a/tools/tinker/tinker2lmp.py b/tools/tinker/tinker2lmp.py index 3d871747b6..565d3f23fe 100644 --- a/tools/tinker/tinker2lmp.py +++ b/tools/tinker/tinker2lmp.py @@ -10,6 +10,8 @@ # -bitorsion file = LAMMPS fix bitorsion file to output (required if BiTorsions) # -nopbc = non-periodic system (default) # -pbc xhi yhi zhi = periodic system from 0 to hi in each dimension (optional) +# -rep Nx Ny Nz outfile = replicate periodic system by Nx by Ny by Nz (optional) +# outfile = new xyz file to write out, Null if no file # Author: Steve Plimpton @@ -43,8 +45,10 @@ def error(txt=""): class XYZfile: def __init__(self,file): lines = open(file,'r').readlines() + header = lines[0] natoms = int(lines[0].split()[0]) id = [] + label = [] type = [] x = [] y = [] @@ -54,6 +58,7 @@ class XYZfile: for line in lines[1:natoms+1]: words = line.split() id.append(int(words[0])) + label.append(words[1]) x.append(words[2]) y.append(words[3]) z.append(words[4]) @@ -61,15 +66,171 @@ class XYZfile: blist = words[6:] blist = [int(one) for one in blist] bonds.append(blist) - + + self.header = header self.natoms = natoms self.id = id + self.label = label self.type = type self.x = x self.y = y self.z = z self.bonds = bonds + # set bond images flags in each dim for each bond of each atom + # used for replication of a periodic system + # 0 = bond partner is closer then half box in dim + # -1 = bond partner is on other side of lower box bound in dim + # +1 = bond partner is on other side of upper box bound in dim + + def bond_images(self): + + xhalfsq = 0.25 * boxhi[0]*boxhi[0] + yhalfsq = 0.25 * boxhi[1]*boxhi[1] + zhalfsq = 0.25 * boxhi[2]*boxhi[2] + + x = self.x + y = self.y + z = self.z + bonds = self.bonds + imageflags = [] + + for i in range(self.natoms): + xi = float(x[i]) + yi = float(y[i]) + zi = float(z[i]) + oneflags = [] + + for j in bonds[i]: + xj = float(x[j-1]) + yj = float(y[j-1]) + zj = float(z[j-1]) + dx = xi - xj + dy = yi - yj + dz = zi - zj + + if dx*dx <= xhalfsq: ximage = 0 + elif xi < xj: ximage = -1 + elif xi > xj: ximage = 1 + if dy*dy <= yhalfsq: yimage = 0 + elif yi < yj: yimage = -1 + elif yi > yj: yimage = 1 + if dz*dz <= zhalfsq: zimage = 0 + elif zi < zj: zimage = -1 + elif zi > zj: zimage = 1 + oneflags.append((ximage,yimage,zimage)) + + imageflags.append(oneflags) + + self.imageflags = imageflags + + # replicate system by Nx and Ny and Nz in each dim + # rebuild data structs (except imageflags) in this class + # also alter global boxhi + + def replicate(self,nx,ny,nz): + + natoms = self.natoms + id = self.id + label = self.label + type = self.type + x = self.x + y = self.y + z = self.z + bonds = self.bonds + imageflags = self.imageflags + + xbox = boxhi[0] + ybox = boxhi[1] + zbox = boxhi[2] + + idnew = [] + labelnew = [] + typenew = [] + xnew = [] + ynew = [] + znew = [] + bondsnew = [] + + count = 0 + for k in range(nz): + for j in range(ny): + for i in range(nx): + for m in range(natoms): + count += 1 + idnew.append(count) + labelnew.append(label[m]) + typenew.append(type[m]) + xnew.append(str(float(x[m]) + i*xbox)) + ynew.append(str(float(y[m]) + j*ybox)) + znew.append(str(float(z[m]) + k*zbox)) + + oneflags = imageflags[m] + onebonds = [] + + for n,mbond in enumerate(bonds[m]): + + # ijk new = which replicated box the mbond atom is in + + if oneflags[n][0] == 0: inew = i + elif oneflags[n][0] == -1: inew = i - 1 + elif oneflags[n][0] == 1: inew = i + 1 + if inew < 0: inew = nx-1 + if inew == nx: inew = 0 + + if oneflags[n][1] == 0: jnew = j + elif oneflags[n][1] == -1: jnew = j - 1 + elif oneflags[n][1] == 1: jnew = j + 1 + if jnew < 0: jnew = ny-1 + if jnew == ny: jnew = 0 + + if oneflags[n][2] == 0: knew = k + elif oneflags[n][2] == -1: knew = k - 1 + elif oneflags[n][2] == 1: knew = k + 1 + if knew < 0: knew = nz-1 + if knew == nz: knew = 0 + + # bondnew = replicated atom ID of bond partner + # based on replication box (inew,jnew,knew) that owns it + + bondnew = mbond + natoms*(knew*ny*nx + jnew*nx + inew) + onebonds.append(bondnew) + + bondsnew.append(onebonds) + + self.natoms = natoms * nx*ny*nz + self.id = idnew + self.label = labelnew + self.type = typenew + self.x = xnew + self.y = ynew + self.z = znew + self.bonds = bondsnew + + # write out new xyzfile for replicated system + + def output(self,outfile): + fp = open(outfile,'w') + words = self.header.split() + print >>fp,self.natoms,"replicated",' '.join(words[1:]) + + id = self.id + label = self.label + type = self.type + x = self.x + y = self.y + z = self.z + bonds = self.bonds + + # NOTE: worry about formatting of line + + for i in range(self.natoms): + print >>fp,i+1,label[i],x[i],y[i],z[i],type[i], + for j in bonds[i]: print >>fp,j, + print >>fp + + fp.close() + # triplet of atoms in an angle = atom 1,2,3 # atom2 is center atom # nbonds = number of atoms which atom2 is bonded to @@ -157,6 +318,26 @@ class PRMfile: iline += 1 return classes,masses + # replicate per-atom data: classes and masses + + def replicate_peratom(self,nx,ny,nz): + classes = self.classes + masses = self.masses + natoms = len(self.masses) + + classes_new = [] + masses_new = [] + + for k in range(nz): + for j in range(ny): + for i in range(nx): + for m in range(natoms): + classes_new.append(classes[m]) + masses_new.append(masses[m]) + + self.classes = classes_new + self.masses = masses_new + # polarization groups def polarize(self): @@ -476,6 +657,7 @@ prmfile = "" datafile = "" bitorsionfile = "" pbcflag = 0 +repflag = 0 iarg = 0 while iarg < narg: @@ -512,6 +694,15 @@ while iarg < narg: zhi = float(args[iarg+3]) boxhi = [xhi,yhi,zhi] iarg += 4 + elif args[iarg] == "-rep": + if iarg + 5 > narg: error() + repflag = 1 + nxrep = int(args[iarg+1]) + nyrep = int(args[iarg+2]) + nzrep = int(args[iarg+3]) + outxyz = args[iarg+4] + if outxyz == "NULL": outxyz = "" + iarg += 5 else: error() # error check @@ -519,12 +710,27 @@ while iarg < narg: if not xyzfile: error("xyzfile not specified") if not prmfile: error("prmfile not specified") if not datafile: error("datafile not specified") - +if not pbcflag and repflag: error("cannot replicate non-periodic system") +if repflag and (nxrep <= 0 or nyrep <= 0 or nzrep <= 0): + error("replication factors <= 0 not allowed") + # read Tinker xyz and prm files xyz = XYZfile(xyzfile) prm = PRMfile(prmfile) +# replicate system if requested +# both in XYZ and PRM classes + +if repflag: + xyz.bond_images() + xyz.replicate(nxrep,nyrep,nzrep) + if outxyz: xyz.output(outxyz) + prm.replicate_peratom(nxrep,nyrep,nzrep) + boxhi[0] *= nxrep + boxhi[1] *= nyrep + boxhi[2] *= nzrep + # create LAMMPS box bounds based on pbcflag natoms = xyz.natoms From 217b07020452f55c6fc5d4014ccb51640858c581 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 1 Jun 2022 15:31:49 -0400 Subject: [PATCH 278/585] add unit tests --- unittest/force-styles/tests/1-1-1.table | 1875 +++++++++ unittest/force-styles/tests/1-1-2.table | 3459 +++++++++++++++++ .../tests/atomic-pair-sw_angle_table.yaml | 97 + .../tests/atomic-pair-threebody_table.yaml | 98 + unittest/force-styles/tests/spce.sw | 18 + unittest/force-styles/tests/spce2.3b | 71 + unittest/force-styles/tests/table_CG_CG.txt | 1203 ++++++ .../force-styles/tests/table_CG_CG_CG.txt | 1004 +++++ 8 files changed, 7825 insertions(+) create mode 100644 unittest/force-styles/tests/1-1-1.table create mode 100644 unittest/force-styles/tests/1-1-2.table create mode 100644 unittest/force-styles/tests/atomic-pair-sw_angle_table.yaml create mode 100644 unittest/force-styles/tests/atomic-pair-threebody_table.yaml create mode 100644 unittest/force-styles/tests/spce.sw create mode 100644 unittest/force-styles/tests/spce2.3b create mode 100644 unittest/force-styles/tests/table_CG_CG.txt create mode 100644 unittest/force-styles/tests/table_CG_CG_CG.txt diff --git a/unittest/force-styles/tests/1-1-1.table b/unittest/force-styles/tests/1-1-1.table new file mode 100644 index 0000000000..76d8f8a9ec --- /dev/null +++ b/unittest/force-styles/tests/1-1-1.table @@ -0,0 +1,1875 @@ +ENTRY1 +N 12 rmin 2.55 rmax 3.65 + +1 2.55 2.55 3.75 -867.212 -611.273 867.212 21386.8 611.273 -21386.8 0.0 +2 2.55 2.55 11.25 -621.539 -411.189 621.539 5035.95 411.189 -5035.95 0.0 +3 2.55 2.55 18.75 -394.167 -243.287 394.167 1722.21 243.287 -1722.21 0.0 +4 2.55 2.55 26.25 -218.789 -127.402 218.789 560.206 127.402 -560.206 0.0 +5 2.55 2.55 33.75 -104.252 -59.5774 104.252 156.639 59.5774 -156.639 0.0 +6 2.55 2.55 41.25 -41.0722 -24.6716 41.072 36.4446 24.6716 -36.4446 0.0 +7 2.55 2.55 48.75 -12.357 -8.38061 12.3571 7.1117 8.38062 -7.1117 0.0 +8 2.55 2.55 56.25 -2.29912 -1.68047 2.29907 0.91657 1.68048 -0.916568 0.0 +9 2.55 2.55 63.75 -0.0509977 0.327321 0.0509129 -0.304729 -0.327319 0.30474 0.0 +10 2.55 2.55 71.25 0.0345509 0.431792 -0.0345867 -0.382614 -0.431782 0.382616 0.0 +11 2.55 2.55 78.75 -0.00019898 0.179593 0.000319523 -0.292658 -0.179608 0.292661 0.0 +12 2.55 2.55 86.25 0.154169 0.138217 -0.154088 -0.302917 -0.138224 0.302914 0.0 +13 2.55 2.55 93.75 0.327691 0.263922 -0.327675 -0.340147 -0.263894 0.340148 0.0 +14 2.55 2.55 101.25 0.382895 0.350591 -0.382883 -0.297308 -0.350546 0.297312 0.0 +15 2.55 2.55 108.75 0.300955 0.297417 -0.300746 -0.173862 -0.297437 0.173872 0.0 +16 2.55 2.55 116.25 0.138507 0.141879 -0.138328 -0.0349372 -0.1418 0.0349415 0.0 +17 2.55 2.55 123.75 -0.0287949 -0.0286834 0.0286744 0.065848 0.0287665 -0.0658601 0.0 +18 2.55 2.55 131.25 -0.160323 -0.164235 0.160302 0.120341 0.164191 -0.120297 0.0 +19 2.55 2.55 138.75 -0.274013 -0.280673 0.274077 0.156939 0.280642 -0.156913 0.0 +20 2.55 2.55 146.25 -0.42361 -0.430992 0.423711 0.212433 0.430824 -0.212358 0.0 +21 2.55 2.55 153.75 -0.648177 -0.651719 0.648516 0.305821 0.651726 -0.305791 0.0 +22 2.55 2.55 161.25 -0.93181 -0.926724 0.931895 0.426805 0.926702 -0.426778 0.0 +23 2.55 2.55 168.75 -1.20276 -1.18735 1.20273 0.541966 1.18745 -0.542019 0.0 +24 2.55 2.55 176.25 -1.36933 -1.34705 1.3691 0.612284 1.34703 -0.612297 0.0 +25 2.55 2.65 3.75 -784.444 -675.519 784.444 19696.9 675.519 -19696.9 0.0 +26 2.55 2.65 11.25 -542.941 -440.852 542.941 5300.59 440.852 -5300.59 0.0 +27 2.55 2.65 18.75 -325.839 -241.234 325.839 1817.37 241.234 -1817.37 0.0 +28 2.55 2.65 26.25 -169.421 -111.015 169.421 580.214 111.015 -580.214 0.0 +29 2.55 2.65 33.75 -74.994 -43.3669 74.994 155.496 43.3669 -155.496 0.0 +30 2.55 2.65 41.25 -27.0736 -14.8824 27.0736 33.1152 14.8824 -33.1152 0.0 +31 2.55 2.65 48.75 -7.12613 -4.62454 7.12621 5.36809 4.62453 -5.36811 0.0 +32 2.55 2.65 56.25 -0.874199 -1.13723 0.874234 0.34195 1.13723 -0.341919 0.0 +33 2.55 2.65 63.75 0.204812 -0.0406907 -0.204883 -0.442652 0.0407084 0.442642 0.0 +34 2.55 2.65 71.25 0.0904568 0.154881 -0.0905494 -0.435451 -0.154894 0.435459 0.0 +35 2.55 2.65 78.75 0.0458835 0.126591 -0.0460614 -0.333955 -0.126573 0.33396 0.0 +36 2.55 2.65 86.25 0.168148 0.163197 -0.168343 -0.309845 -0.163197 0.309848 0.0 +37 2.55 2.65 93.75 0.296449 0.261093 -0.296361 -0.307947 -0.261084 0.307954 0.0 +38 2.55 2.65 101.25 0.329963 0.311331 -0.329831 -0.254571 -0.311318 0.254565 0.0 +39 2.55 2.65 108.75 0.253841 0.255391 -0.253789 -0.146686 -0.255437 0.146721 0.0 +40 2.55 2.65 116.25 0.107857 0.119105 -0.107492 -0.0254819 -0.119136 0.0254837 0.0 +41 2.55 2.65 123.75 -0.0492191 -0.0344023 0.0490594 0.0707149 0.0343792 -0.0707119 0.0 +42 2.55 2.65 131.25 -0.180513 -0.166858 0.180388 0.1322 0.16692 -0.132248 0.0 +43 2.55 2.65 138.75 -0.300448 -0.291041 0.300451 0.178321 0.291015 -0.178345 0.0 +44 2.55 2.65 146.25 -0.45666 -0.451363 0.456715 0.239144 0.451427 -0.239145 0.0 +45 2.55 2.65 153.75 -0.684349 -0.67857 0.684481 0.332093 0.678651 -0.332112 0.0 +46 2.55 2.65 161.25 -0.966732 -0.954719 0.966651 0.448833 0.954615 -0.448783 0.0 +47 2.55 2.65 168.75 -1.23353 -1.21297 1.23383 0.558954 1.21297 -0.558949 0.0 +48 2.55 2.65 176.25 -1.39695 -1.37031 1.39698 0.626037 1.37022 -0.625967 0.0 +49 2.55 2.75 3.75 -668.413 -701.057 668.413 15096.3 701.057 -15096.3 0.0 +50 2.55 2.75 11.25 -452.8 -464.411 452.8 5130.32 464.411 -5130.32 0.0 +51 2.55 2.75 18.75 -256.012 -246.87 256.012 1797.07 246.87 -1797.07 0.0 +52 2.55 2.75 26.25 -123.333 -105.643 123.333 565.052 105.643 -565.052 0.0 +53 2.55 2.75 33.75 -50.2709 -35.7913 50.2709 144.93 35.7913 -144.93 0.0 +54 2.55 2.75 41.25 -16.78 -9.69921 16.78 28.1038 9.69923 -28.1038 0.0 +55 2.55 2.75 48.75 -4.12155 -2.37411 4.12164 3.76214 2.3741 -3.76217 0.0 +56 2.55 2.75 56.25 -0.484016 -0.658362 0.484128 0.146857 0.658338 -0.146846 0.0 +57 2.55 2.75 63.75 0.0687647 -0.20106 -0.0687734 -0.260534 0.20103 0.260497 0.0 +58 2.55 2.75 71.25 -0.00147066 -0.0603687 0.0015277 -0.268714 0.0604159 0.268722 0.0 +59 2.55 2.75 78.75 0.0156999 0.0125791 -0.0159656 -0.252993 -0.0125614 0.252974 0.0 +60 2.55 2.75 86.25 0.136925 0.119249 -0.13684 -0.269725 -0.11924 0.269725 0.0 +61 2.55 2.75 93.75 0.247327 0.234358 -0.247334 -0.272826 -0.234332 0.272827 0.0 +62 2.55 2.75 101.25 0.281753 0.286511 -0.281826 -0.224691 -0.286549 0.224691 0.0 +63 2.55 2.75 108.75 0.226138 0.242659 -0.226349 -0.131815 -0.24272 0.131841 0.0 +64 2.55 2.75 116.25 0.106433 0.12752 -0.10664 -0.0258695 -0.127594 0.0258609 0.0 +65 2.55 2.75 123.75 -0.0277616 -0.00630627 0.0276778 0.0615222 0.00630865 -0.0614969 0.0 +66 2.55 2.75 131.25 -0.142446 -0.124893 0.142414 0.118979 0.124975 -0.11903 0.0 +67 2.55 2.75 138.75 -0.248783 -0.237903 0.248779 0.161562 0.237995 -0.161575 0.0 +68 2.55 2.75 146.25 -0.392668 -0.385233 0.392627 0.216964 0.385134 -0.21689 0.0 +69 2.55 2.75 153.75 -0.606858 -0.595071 0.606818 0.302592 0.595088 -0.302606 0.0 +70 2.55 2.75 161.25 -0.874793 -0.851019 0.874799 0.411383 0.850969 -0.411357 0.0 +71 2.55 2.75 168.75 -1.12893 -1.0911 1.12904 0.514712 1.09102 -0.514675 0.0 +72 2.55 2.75 176.25 -1.28457 -1.23755 1.28455 0.577854 1.23747 -0.577828 0.0 +73 2.55 2.85 3.75 -540.757 -671.949 540.757 11232.9 671.949 -11232.9 0.0 +74 2.55 2.85 11.25 -358.962 -456.955 358.962 4626.32 456.955 -4626.32 0.0 +75 2.55 2.85 18.75 -189.205 -242.387 189.205 1670.73 242.387 -1670.73 0.0 +76 2.55 2.85 26.25 -82.3789 -101.034 82.3789 518.217 101.034 -518.217 0.0 +77 2.55 2.85 33.75 -30.0098 -32.1026 30.0098 126.998 32.1025 -126.998 0.0 +78 2.55 2.85 41.25 -9.21751 -7.56922 9.21749 22.2838 7.5692 -22.2838 0.0 +79 2.55 2.85 48.75 -2.28489 -1.50529 2.28485 2.35574 1.50529 -2.35573 0.0 +80 2.55 2.85 56.25 -0.358049 -0.489852 0.357948 0.0188984 0.489874 -0.0189109 0.0 +81 2.55 2.85 63.75 -0.00522043 -0.307792 0.00494878 -0.134592 0.307776 0.134574 0.0 +82 2.55 2.85 71.25 0.00323495 -0.2024 -0.00313048 -0.169997 0.202387 0.169981 0.0 +83 2.55 2.85 78.75 0.0415278 -0.0778296 -0.0414056 -0.213315 0.077898 0.213326 0.0 +84 2.55 2.85 86.25 0.131889 0.069504 -0.132199 -0.248098 -0.0695577 0.248098 0.0 +85 2.55 2.85 93.75 0.214594 0.193542 -0.214655 -0.244475 -0.193398 0.244477 0.0 +86 2.55 2.85 101.25 0.244494 0.247624 -0.244635 -0.195685 -0.247697 0.195696 0.0 +87 2.55 2.85 108.75 0.201434 0.218545 -0.201617 -0.114828 -0.218615 0.114846 0.0 +88 2.55 2.85 116.25 0.0998591 0.127904 -0.0997024 -0.024899 -0.127956 0.0249269 0.0 +89 2.55 2.85 123.75 -0.0181479 0.0163555 0.0181766 0.049407 -0.0163067 -0.0494209 0.0 +90 2.55 2.85 131.25 -0.11898 -0.0876934 0.119352 0.098005 0.0875449 -0.0979311 0.0 +91 2.55 2.85 138.75 -0.214707 -0.191866 0.214605 0.134596 0.191898 -0.13457 0.0 +92 2.55 2.85 146.25 -0.347993 -0.330815 0.348041 0.185048 0.330869 -0.185107 0.0 +93 2.55 2.85 153.75 -0.550177 -0.528952 0.549981 0.265291 0.528797 -0.265232 0.0 +94 2.55 2.85 161.25 -0.804311 -0.769737 0.804194 0.367848 0.769696 -0.367861 0.0 +95 2.55 2.85 168.75 -1.04529 -0.994652 1.04554 0.465186 0.99499 -0.465282 0.0 +96 2.55 2.85 176.25 -1.19281 -1.13166 1.19305 0.52457 1.13177 -0.524594 0.0 +97 2.55 2.95 3.75 -419.502 -582.296 419.502 8332.23 582.296 -8332.23 0.0 +98 2.55 2.95 11.25 -271.55 -404.417 271.55 3930.48 404.417 -3930.48 0.0 +99 2.55 2.95 18.75 -130.928 -214.969 130.928 1464.2 214.969 -1464.2 0.0 +100 2.55 2.95 26.25 -48.786 -88.4342 48.786 447.646 88.4342 -447.646 0.0 +101 2.55 2.95 33.75 -14.3964 -27.3665 14.3964 104.519 27.3665 -104.519 0.0 +102 2.55 2.95 41.25 -3.7883 -6.20808 3.78827 16.4944 6.20806 -16.4944 0.0 +103 2.55 2.95 48.75 -1.0529 -1.19869 1.05292 1.27167 1.19863 -1.27161 0.0 +104 2.55 2.95 56.25 -0.231522 -0.429682 0.231513 -0.0951674 0.429629 0.0951268 0.0 +105 2.55 2.95 63.75 0.0181127 -0.325032 -0.0180919 -0.110423 0.324922 0.110426 0.0 +106 2.55 2.95 71.25 0.049094 -0.246096 -0.0491496 -0.144969 0.245996 0.14495 0.0 +107 2.55 2.95 78.75 0.063364 -0.114463 -0.0633467 -0.196803 0.114426 0.196797 0.0 +108 2.55 2.95 86.25 0.11583 0.0385036 -0.115786 -0.223948 -0.0384687 0.223952 0.0 +109 2.55 2.95 93.75 0.177943 0.156855 -0.178064 -0.209887 -0.156845 0.209889 0.0 +110 2.55 2.95 101.25 0.207654 0.212381 -0.207593 -0.163549 -0.212444 0.163567 0.0 +111 2.55 2.95 108.75 0.175031 0.201414 -0.174609 -0.0967898 -0.20124 0.0967398 0.0 +112 2.55 2.95 116.25 0.0862557 0.136066 -0.0862066 -0.0233966 -0.13596 0.0233258 0.0 +113 2.55 2.95 123.75 -0.0191239 0.0441682 0.0193287 0.0382847 -0.0441811 -0.0382953 0.0 +114 2.55 2.95 131.25 -0.110069 -0.050979 0.109801 0.0798251 0.0509319 -0.0799025 0.0 +115 2.55 2.95 138.75 -0.196213 -0.153394 0.196102 0.113373 0.153405 -0.113396 0.0 +116 2.55 2.95 146.25 -0.318885 -0.291367 0.319145 0.161467 0.291373 -0.161505 0.0 +117 2.55 2.95 153.75 -0.50686 -0.483737 0.506732 0.236963 0.48342 -0.236818 0.0 +118 2.55 2.95 161.25 -0.742764 -0.712982 0.742837 0.331712 0.713077 -0.331758 0.0 +119 2.55 2.95 168.75 -0.965814 -0.924655 0.965837 0.420445 0.924729 -0.420487 0.0 +120 2.55 2.95 176.25 -1.10185 -1.05258 1.10198 0.474136 1.05241 -0.474051 0.0 +121 2.55 3.05 3.75 -319.111 -440.938 319.111 6126.66 440.938 -6126.66 0.0 +122 2.55 3.05 11.25 -200.795 -309.049 200.795 3169.23 309.049 -3169.23 0.0 +123 2.55 3.05 18.75 -86.7152 -162.683 86.7152 1211.49 162.683 -1211.49 0.0 +124 2.55 3.05 26.25 -24.7922 -65.0953 24.7921 363.733 65.0953 -363.733 0.0 +125 2.55 3.05 33.75 -3.79557 -19.4403 3.79568 80.4622 19.4403 -80.4622 0.0 +126 2.55 3.05 41.25 -0.227488 -4.40816 0.227381 11.3442 4.40812 -11.3442 0.0 +127 2.55 3.05 48.75 -0.215962 -0.9846 0.21623 0.572809 0.984607 -0.572833 0.0 +128 2.55 3.05 56.25 -0.0972827 -0.406271 0.0971886 -0.155442 0.406388 0.155438 0.0 +129 2.55 3.05 63.75 0.0474691 -0.320721 -0.0473142 -0.115525 0.320742 0.115541 0.0 +130 2.55 3.05 71.25 0.0542543 -0.274312 -0.0545515 -0.127569 0.274174 0.127517 0.0 +131 2.55 3.05 78.75 0.0439985 -0.158092 -0.0440511 -0.165185 0.158055 0.165194 0.0 +132 2.55 3.05 86.25 0.0821507 -0.00877884 -0.0821081 -0.183829 0.00887135 0.183832 0.0 +133 2.55 3.05 93.75 0.142245 0.109192 -0.142406 -0.168613 -0.109223 0.168609 0.0 +134 2.55 3.05 101.25 0.176786 0.175042 -0.176859 -0.131259 -0.174989 0.13127 0.0 +135 2.55 3.05 108.75 0.153044 0.185839 -0.153188 -0.0796497 -0.185913 0.0796723 0.0 +136 2.55 3.05 116.25 0.0762661 0.144574 -0.0760233 -0.0213083 -0.14475 0.0213947 0.0 +137 2.55 3.05 123.75 -0.0153973 0.0697421 0.0151775 0.0294442 -0.0697414 -0.0295136 0.0 +138 2.55 3.05 131.25 -0.0914496 -0.0164558 0.0915457 0.0650391 0.01638 -0.0650155 0.0 +139 2.55 3.05 138.75 -0.163525 -0.114278 0.163505 0.0952572 0.113968 -0.0951433 0.0 +140 2.55 3.05 146.25 -0.267879 -0.245016 0.267903 0.138326 0.244925 -0.138338 0.0 +141 2.55 3.05 153.75 -0.430018 -0.423265 0.429956 0.203867 0.423326 -0.203942 0.0 +142 2.55 3.05 161.25 -0.633833 -0.631774 0.634037 0.284186 0.631568 -0.284063 0.0 +143 2.55 3.05 168.75 -0.826685 -0.82183 0.826375 0.358252 0.82172 -0.358225 0.0 +144 2.55 3.05 176.25 -0.943422 -0.93572 0.943723 0.402697 0.935847 -0.402743 0.0 +145 2.55 3.15 3.75 -249.767 -271.418 249.767 4425.44 271.418 -4425.44 0.0 +146 2.55 3.15 11.25 -154.5 -187.982 154.5 2434.18 187.982 -2434.18 0.0 +147 2.55 3.15 18.75 -60.5981 -94.4639 60.5982 946.499 94.4639 -946.499 0.0 +148 2.55 3.15 26.25 -11.8534 -34.6155 11.8535 277.025 34.6156 -277.025 0.0 +149 2.55 3.15 33.75 1.6123 -9.2646 -1.61231 57.3974 9.26465 -57.3974 0.0 +150 2.55 3.15 41.25 1.60158 -2.19805 -1.60158 7.12692 2.19808 -7.12698 0.0 +151 2.55 3.15 48.75 0.26948 -0.778894 -0.269488 0.21063 0.778852 -0.210617 0.0 +152 2.55 3.15 56.25 -0.01372 -0.412911 0.0136807 -0.142081 0.412893 0.142164 0.0 +153 2.55 3.15 63.75 0.0224038 -0.329718 -0.0222862 -0.0965871 0.329602 0.096574 0.0 +154 2.55 3.15 71.25 0.0060749 -0.316094 -0.00598008 -0.0883032 0.316076 0.0883122 0.0 +155 2.55 3.15 78.75 0.00302628 -0.219142 -0.00292645 -0.117193 0.219165 0.117188 0.0 +156 2.55 3.15 86.25 0.0523024 -0.0705546 -0.0522252 -0.136651 0.0705734 0.136649 0.0 +157 2.55 3.15 93.75 0.115651 0.0544573 -0.11564 -0.126319 -0.0545821 0.126326 0.0 +158 2.55 3.15 101.25 0.148969 0.134261 -0.149041 -0.0986894 -0.134289 0.0986837 0.0 +159 2.55 3.15 108.75 0.128464 0.165022 -0.12849 -0.0608071 -0.165301 0.0608822 0.0 +160 2.55 3.15 116.25 0.0654112 0.144738 -0.0648575 -0.0171687 -0.144771 0.0172192 0.0 +161 2.55 3.15 123.75 -0.00700089 0.0874701 0.0070514 0.0212287 -0.087399 -0.0213181 0.0 +162 2.55 3.15 131.25 -0.0630668 0.0158432 0.0629726 0.0481408 -0.0158028 -0.0482207 0.0 +163 2.55 3.15 138.75 -0.113207 -0.0669731 0.112947 0.0710475 0.0668196 -0.0709779 0.0 +164 2.55 3.15 146.25 -0.189616 -0.177294 0.189595 0.103802 0.177145 -0.103761 0.0 +165 2.55 3.15 153.75 -0.313405 -0.326317 0.313385 0.153359 0.326249 -0.1534 0.0 +166 2.55 3.15 161.25 -0.471349 -0.499401 0.471384 0.2136 0.499615 -0.213641 0.0 +167 2.55 3.15 168.75 -0.621738 -0.656501 0.621526 0.268765 0.656234 -0.268609 0.0 +168 2.55 3.15 176.25 -0.713168 -0.750131 0.713075 0.301728 0.749961 -0.301587 0.0 +169 2.55 3.25 3.75 -215.533 -105.036 215.533 3115.64 105.036 -3115.64 0.0 +170 2.55 3.25 11.25 -135.709 -66.1673 135.709 1782.43 66.1673 -1782.43 0.0 +171 2.55 3.25 18.75 -53.5226 -25.2778 53.5226 697.12 25.2777 -697.12 0.0 +172 2.55 3.25 26.25 -9.76548 -4.05586 9.76548 196.405 4.05587 -196.405 0.0 +173 2.55 3.25 33.75 2.26986 0.661867 -2.26987 37.2172 -0.661895 -37.2172 0.0 +174 2.55 3.25 41.25 1.94008 -0.139655 -1.94016 3.90169 0.139693 -3.90171 0.0 +175 2.55 3.25 48.75 0.433581 -0.598298 -0.433653 0.0713369 0.598313 -0.071257 0.0 +176 2.55 3.25 56.25 -0.0110448 -0.396733 0.0111185 -0.0792235 0.396666 0.0791487 0.0 +177 2.55 3.25 63.75 -0.0512665 -0.306617 0.0511183 -0.0540821 0.306458 0.05412 0.0 +178 2.55 3.25 71.25 -0.0567327 -0.327807 0.0568023 -0.042547 0.327783 0.0424758 0.0 +179 2.55 3.25 78.75 -0.0248985 -0.256832 0.0248957 -0.0738229 0.256924 0.073814 0.0 +180 2.55 3.25 86.25 0.03699 -0.115693 -0.0368212 -0.0949395 0.115771 0.0949412 0.0 +181 2.55 3.25 93.75 0.088578 0.0114051 -0.0885974 -0.0851166 -0.0114329 0.0851098 0.0 +182 2.55 3.25 101.25 0.108379 0.100211 -0.108454 -0.0631833 -0.100386 0.0632103 0.0 +183 2.55 3.25 108.75 0.0905494 0.146067 -0.0902676 -0.0380134 -0.146103 0.0380456 0.0 +184 2.55 3.25 116.25 0.0446648 0.143011 -0.0447651 -0.0105656 -0.143148 0.0105849 0.0 +185 2.55 3.25 123.75 -0.00397982 0.102972 0.00398606 0.0132778 -0.103051 -0.0132872 0.0 +186 2.55 3.25 131.25 -0.0396488 0.0470538 0.0395149 0.0295482 -0.0468879 -0.0296284 0.0 +187 2.55 3.25 138.75 -0.0696427 -0.0184498 0.0696581 0.0434558 0.0182276 -0.0433637 0.0 +188 2.55 3.25 146.25 -0.118295 -0.104198 0.11835 0.0645889 0.104105 -0.0645169 0.0 +189 2.55 3.25 153.75 -0.201226 -0.219646 0.201381 0.0977209 0.219776 -0.0977906 0.0 +190 2.55 3.25 161.25 -0.310278 -0.35328 0.310501 0.138558 0.353454 -0.138633 0.0 +191 2.55 3.25 168.75 -0.415467 -0.474235 0.415053 0.176198 0.474086 -0.176145 0.0 +192 2.55 3.25 176.25 -0.479006 -0.546119 0.479273 0.198749 0.546279 -0.198787 0.0 +193 2.55 3.35 3.75 -204.898 28.1648 204.898 2043.28 -28.1648 -2043.28 0.0 +194 2.55 3.35 11.25 -135.949 31.6213 135.949 1195.68 -31.6213 -1195.68 0.0 +195 2.55 3.35 18.75 -60.0294 29.3309 60.0294 464.081 -29.3309 -464.081 0.0 +196 2.55 3.35 26.25 -15.5602 19.1482 15.5602 123.342 -19.1482 -123.342 0.0 +197 2.55 3.35 33.75 -0.516502 7.80361 0.516464 20.3914 -7.80361 -20.3915 0.0 +198 2.55 3.35 41.25 1.1959 1.28099 -1.1959 1.61912 -1.28089 -1.61917 0.0 +199 2.55 3.35 48.75 0.338664 -0.427486 -0.338735 0.0672361 0.427458 -0.0671949 0.0 +200 2.55 3.35 56.25 -0.0712654 -0.32692 0.0713186 -0.00513307 0.326996 0.00515152 0.0 +201 2.55 3.35 63.75 -0.121975 -0.24598 0.122164 -0.0158901 0.24595 0.0159275 0.0 +202 2.55 3.35 71.25 -0.0836168 -0.3049 0.0833968 -0.0145822 0.304962 0.0145084 0.0 +203 2.55 3.35 78.75 -0.0227775 -0.26582 0.0226797 -0.0466388 0.265827 0.0466007 0.0 +204 2.55 3.35 86.25 0.0253278 -0.141365 -0.0252494 -0.0598516 0.14135 0.0598496 0.0 +205 2.55 3.35 93.75 0.0478277 -0.0194912 -0.0477364 -0.0442668 0.01948 0.0442715 0.0 +206 2.55 3.35 101.25 0.0542989 0.072706 -0.0542353 -0.0265114 -0.0727603 0.0265457 0.0 +207 2.55 3.35 108.75 0.0474436 0.128762 -0.0473722 -0.0142292 -0.128667 0.0141884 0.0 +208 2.55 3.35 116.25 0.024829 0.139676 -0.0246836 -0.00238193 -0.139623 0.00240878 0.0 +209 2.55 3.35 123.75 -0.00477975 0.112522 0.00457921 0.00880631 -0.112295 -0.00892129 0.0 +210 2.55 3.35 131.25 -0.0290626 0.0670303 0.0288612 0.0167144 -0.0668681 -0.0167711 0.0 +211 2.55 3.35 138.75 -0.0488435 0.012812 0.048558 0.0234532 -0.0126738 -0.0236424 0.0 +212 2.55 3.35 146.25 -0.0762617 -0.0554933 0.0763255 0.0346659 0.0553813 -0.0346319 0.0 +213 2.55 3.35 153.75 -0.123726 -0.144228 0.123766 0.053841 0.144227 -0.0538008 0.0 +214 2.55 3.35 161.25 -0.18791 -0.245407 0.187929 0.078822 0.245764 -0.079086 0.0 +215 2.55 3.35 168.75 -0.251038 -0.336304 0.251286 0.102654 0.336317 -0.102638 0.0 +216 2.55 3.35 176.25 -0.29084 -0.390314 0.290697 0.117217 0.390531 -0.11737 0.0 +217 2.55 3.45 3.75 -160.11 78.3904 160.11 964.746 -78.3904 -964.746 0.0 +218 2.55 3.45 11.25 -112.253 65.2155 112.253 569.896 -65.2155 -569.896 0.0 +219 2.55 3.45 18.75 -55.5875 44.2652 55.5876 216.275 -44.2652 -216.275 0.0 +220 2.55 3.45 26.25 -18.577 23.1948 18.5771 52.7785 -23.1948 -52.7785 0.0 +221 2.55 3.45 33.75 -3.3749 8.35207 3.37496 7.08855 -8.35205 -7.08857 0.0 +222 2.55 3.45 41.25 0.0558271 1.43995 -0.0557888 0.416872 -1.44003 -0.416798 0.0 +223 2.55 3.45 48.75 0.0736874 -0.250918 -0.0736577 0.137694 0.25083 -0.137688 0.0 +224 2.55 3.45 56.25 -0.118382 -0.234235 0.118498 0.029723 0.234224 -0.0297093 0.0 +225 2.55 3.45 63.75 -0.103993 -0.193692 0.103998 -0.0111831 0.193659 0.0111847 0.0 +226 2.55 3.45 71.25 -0.0373239 -0.248873 0.0374 -0.0103758 0.248904 0.0103568 0.0 +227 2.55 3.45 78.75 -0.000815577 -0.221711 0.000857674 -0.0239127 0.221702 0.0239331 0.0 +228 2.55 3.45 86.25 0.00235137 -0.12606 -0.00247045 -0.0235691 0.126024 0.0235785 0.0 +229 2.55 3.45 93.75 0.000693468 -0.0322758 -0.000731622 -0.0100368 0.0322426 0.0100472 0.0 +230 2.55 3.45 101.25 0.0107898 0.0378694 -0.0109773 -0.00230259 -0.0379779 0.00230944 0.0 +231 2.55 3.45 108.75 0.0223901 0.0828189 -0.0224924 -0.0011966 -0.0828617 0.00119886 0.0 +232 2.55 3.45 116.25 0.01901 0.0976112 -0.0189845 0.000576941 -0.0977212 -0.000592258 0.0 +233 2.55 3.45 123.75 0.0023177 0.0865526 -0.00220076 0.00381654 -0.0867258 -0.00376165 0.0 +234 2.55 3.45 131.25 -0.0137084 0.0618094 0.0137112 0.00514774 -0.0618168 -0.00513733 0.0 +235 2.55 3.45 138.75 -0.0208603 0.0307928 0.0209021 0.00395318 -0.0306512 -0.00401619 0.0 +236 2.55 3.45 146.25 -0.0246671 -0.00894626 0.0246851 0.00351226 0.00893543 -0.0035253 0.0 +237 2.55 3.45 153.75 -0.0354818 -0.0611658 0.0352745 0.0074458 0.0613979 -0.00758451 0.0 +238 2.55 3.45 161.25 -0.0568268 -0.12175 0.0568015 0.016221 0.121744 -0.0162267 0.0 +239 2.55 3.45 168.75 -0.0825887 -0.177017 0.0826212 0.0265372 0.177062 -0.0266112 0.0 +240 2.55 3.45 176.25 -0.100362 -0.210215 0.100363 0.0334528 0.210225 -0.0334721 0.0 +241 2.55 3.55 3.75 -78.9919 44.1593 78.9919 272.44 -44.1593 -272.44 0.0 +242 2.55 3.55 11.25 -57.4405 35.3664 57.4405 160.985 -35.3664 -160.985 0.0 +243 2.55 3.55 18.75 -30.4327 22.6574 30.4327 59.1789 -22.6574 -59.1789 0.0 +244 2.55 3.55 26.25 -11.3918 11.2259 11.3918 13.1796 -11.2259 -13.1796 0.0 +245 2.55 3.55 33.75 -2.72329 3.8781 2.7233 1.57893 -3.87813 -1.57891 0.0 +246 2.55 3.55 41.25 -0.349405 0.648596 0.349417 0.278163 -0.648614 -0.278143 0.0 +247 2.55 3.55 48.75 -0.0951034 -0.129698 0.0950942 0.144918 0.129704 -0.144907 0.0 +248 2.55 3.55 56.25 -0.0904303 -0.132617 0.0904025 -0.000622582 0.13263 0.000613981 0.0 +249 2.55 3.55 63.75 -0.0258623 -0.110734 0.0258374 -0.0284537 0.110749 0.0284432 0.0 +250 2.55 3.55 71.25 0.0130336 -0.121492 -0.0129784 -0.00958708 0.121519 0.0095864 0.0 +251 2.55 3.55 78.75 0.00216509 -0.0947175 -0.00212262 -0.00146876 0.0947229 0.0014866 0.0 +252 2.55 3.55 86.25 -0.0193046 -0.044118 0.0193305 0.000949206 0.0440946 -0.000951166 0.0 +253 2.55 3.55 93.75 -0.0204643 -0.00523306 0.0203838 0.00128217 0.00527308 -0.00128181 0.0 +254 2.55 3.55 101.25 -0.00377452 0.0162146 0.00374878 -0.00203826 -0.0161878 0.00203335 0.0 +255 2.55 3.55 108.75 0.0103855 0.0283922 -0.0103646 -0.00590355 -0.0284035 0.0059097 0.0 +256 2.55 3.55 116.25 0.0107496 0.0355757 -0.0107487 -0.00748469 -0.0355346 0.00746902 0.0 +257 2.55 3.55 123.75 0.00390058 0.039282 -0.00394485 -0.00836899 -0.0392871 0.00836606 0.0 +258 2.55 3.55 131.25 0.00302193 0.0417158 -0.00303302 -0.0116169 -0.0417316 0.0116365 0.0 +259 2.55 3.55 138.75 0.0132809 0.0429902 -0.0132594 -0.0177461 -0.0429583 0.0177101 0.0 +260 2.55 3.55 146.25 0.0286472 0.040296 -0.0286569 -0.0242602 -0.0403293 0.0242749 0.0 +261 2.55 3.55 153.75 0.0390318 0.0306394 -0.039064 -0.0280589 -0.0306446 0.028059 0.0 +262 2.55 3.55 161.25 0.0394296 0.0147367 -0.0394103 -0.0279664 -0.0146398 0.0279268 0.0 +263 2.55 3.55 168.75 0.0324474 -0.00226708 -0.0324635 -0.0253945 0.00220765 0.0254368 0.0 +264 2.55 3.55 176.25 0.025994 -0.013213 -0.0260157 -0.0230769 0.0131899 0.0230844 0.0 +265 2.55 3.65 3.75 -10.2735 4.76327 10.2735 20.7201 -4.76327 -20.7201 0.0 +266 2.55 3.65 11.25 -7.59679 3.74938 7.59679 12.2716 -3.74938 -12.2716 0.0 +267 2.55 3.65 18.75 -4.13373 2.33527 4.13373 4.48711 -2.33527 -4.48711 0.0 +268 2.55 3.65 26.25 -1.60809 1.11951 1.60809 1.05798 -1.11951 -1.05798 0.0 +269 2.55 3.65 33.75 -0.426582 0.367384 0.426586 0.237798 -0.367384 -0.237797 0.0 +270 2.55 3.65 41.25 -0.0923209 0.0481501 0.0923222 0.103116 -0.0481492 -0.103116 0.0 +271 2.55 3.65 48.75 -0.0403716 -0.019861 0.0403721 0.0289419 0.0198609 -0.0289447 0.0 +272 2.55 3.65 56.25 -0.0181588 -0.0104242 0.018157 -0.0111623 0.010423 0.0111643 0.0 +273 2.55 3.65 63.75 0.0026199 -0.0022943 -0.00261809 -0.0112332 0.00229608 0.011234 0.0 +274 2.55 3.65 71.25 0.00555137 -0.00054609 -0.00554585 -0.000901878 0.000542356 0.000901001 0.0 +275 2.55 3.65 78.75 -0.00349077 0.00348611 0.00348128 0.00388527 -0.0034823 -0.00388526 0.0 +276 2.55 3.65 86.25 -0.00986876 0.00759326 0.00986851 0.00334418 -0.00759374 -0.00334402 0.0 +277 2.55 3.65 93.75 -0.00861045 0.00735376 0.00861467 0.000656354 -0.00735444 -0.000656104 0.0 +278 2.55 3.65 101.25 -0.00414524 0.00377925 0.00414321 -0.00212584 -0.00377449 0.00212561 0.0 +279 2.55 3.65 108.75 -0.00169477 0.000439308 0.00169322 -0.00396038 -0.000442715 0.00396063 0.0 +280 2.55 3.65 116.25 -0.00201868 -0.000719026 0.00201981 -0.0047974 0.000729887 0.00479364 0.0 +281 2.55 3.65 123.75 -0.0022902 0.000305603 0.00229371 -0.00529632 -0.000307648 0.00529785 0.0 +282 2.55 3.65 131.25 6.5658e-05 0.00293592 -6.35245e-05 -0.00609152 -0.00294529 0.00609664 0.0 +283 2.55 3.65 138.75 0.00496513 0.00653024 -0.0049612 -0.00723673 -0.00653204 0.00723752 0.0 +284 2.55 3.65 146.25 0.0100844 0.0103162 -0.0100899 -0.0082568 -0.0103134 0.00825192 0.0 +285 2.55 3.65 153.75 0.013056 0.0135185 -0.0130568 -0.00863418 -0.0135186 0.00863497 0.0 +286 2.55 3.65 161.25 0.0130732 0.0156428 -0.013084 -0.00825131 -0.0156473 0.00825326 0.0 +287 2.55 3.65 168.75 0.0112797 0.0167179 -0.0112803 -0.00747124 -0.0167224 0.00747658 0.0 +288 2.55 3.65 176.25 0.0096521 0.0170897 -0.00964981 -0.00687278 -0.0170876 0.00686999 0.0 +289 2.65 2.65 3.75 -850.9 -766.532 850.9 24206.3 766.532 -24206.3 0.0 +290 2.65 2.65 11.25 -532.471 -481.095 532.471 5590.03 481.095 -5590.03 0.0 +291 2.65 2.65 18.75 -284.368 -250.886 284.368 1834.01 250.886 -1834.01 0.0 +292 2.65 2.65 26.25 -129.075 -106.598 129.075 555.283 106.598 -555.283 0.0 +293 2.65 2.65 33.75 -49.9399 -36.5293 49.9399 138.315 36.5293 -138.315 0.0 +294 2.65 2.65 41.25 -16.5129 -10.4032 16.5129 27.2019 10.4033 -27.2019 0.0 +295 2.65 2.65 48.75 -4.46528 -2.7076 4.46539 4.42411 2.70761 -4.42411 0.0 +296 2.65 2.65 56.25 -0.741021 -0.597377 0.741105 0.305553 0.597353 -0.305549 0.0 +297 2.65 2.65 63.75 0.104606 0.0237456 -0.104669 -0.572899 -0.0237444 0.572894 0.0 +298 2.65 2.65 71.25 0.139391 0.125946 -0.139515 -0.571709 -0.125927 0.571698 0.0 +299 2.65 2.65 78.75 0.104219 0.102894 -0.104113 -0.382665 -0.102882 0.382676 0.0 +300 2.65 2.65 86.25 0.157087 0.145852 -0.157232 -0.297431 -0.1459 0.297442 0.0 +301 2.65 2.65 93.75 0.240407 0.236266 -0.240541 -0.278188 -0.236265 0.27819 0.0 +302 2.65 2.65 101.25 0.275238 0.279291 -0.274988 -0.229799 -0.27936 0.229805 0.0 +303 2.65 2.65 108.75 0.227141 0.229356 -0.227284 -0.134968 -0.229285 0.134932 0.0 +304 2.65 2.65 116.25 0.115892 0.112442 -0.115868 -0.0291153 -0.112422 0.0291383 0.0 +305 2.65 2.65 123.75 -0.010285 -0.0162117 0.0103961 0.0530193 0.0161505 -0.0529991 0.0 +306 2.65 2.65 131.25 -0.1188 -0.124881 0.118875 0.104487 0.124916 -0.104492 0.0 +307 2.65 2.65 138.75 -0.223058 -0.229731 0.223369 0.145724 0.229737 -0.145685 0.0 +308 2.65 2.65 146.25 -0.368701 -0.376052 0.368859 0.205686 0.3761 -0.205685 0.0 +309 2.65 2.65 153.75 -0.587337 -0.594228 0.587423 0.299459 0.594372 -0.299509 0.0 +310 2.65 2.65 161.25 -0.859864 -0.865453 0.859988 0.416736 0.865344 -0.416708 0.0 +311 2.65 2.65 168.75 -1.11756 -1.12156 1.11739 0.526563 1.12147 -0.526502 0.0 +312 2.65 2.65 176.25 -1.2751 -1.27817 1.27506 0.593124 1.2781 -0.593061 0.0 +313 2.65 2.75 3.75 -835.182 -772.341 835.182 21905.9 772.341 -21905.9 0.0 +314 2.65 2.75 11.25 -513.694 -481.73 513.694 5723.06 481.73 -5723.06 0.0 +315 2.65 2.75 18.75 -261.725 -240.477 261.725 1876.13 240.477 -1876.13 0.0 +316 2.65 2.75 26.25 -110.82 -93.042 110.82 555.313 93.0419 -555.313 0.0 +317 2.65 2.75 33.75 -39.2645 -26.3478 39.2645 131.64 26.3478 -131.64 0.0 +318 2.65 2.75 41.25 -11.8937 -5.23302 11.8938 23.3148 5.233 -23.3148 0.0 +319 2.65 2.75 48.75 -3.05671 -0.993603 3.05657 3.14407 0.993621 -3.14406 0.0 +320 2.65 2.75 56.25 -0.550099 -0.358525 0.550227 0.163089 0.358498 -0.163112 0.0 +321 2.65 2.75 63.75 -0.0205929 -0.0842747 0.0205161 -0.407995 0.0842518 0.407956 0.0 +322 2.65 2.75 71.25 0.00336668 0.0345981 -0.00349936 -0.421497 -0.0346157 0.421506 0.0 +323 2.65 2.75 78.75 0.0253619 0.0593683 -0.0255874 -0.3063 -0.0593531 0.306294 0.0 +324 2.65 2.75 86.25 0.119248 0.114375 -0.119305 -0.255219 -0.114285 0.255229 0.0 +325 2.65 2.75 93.75 0.216069 0.202657 -0.216049 -0.241183 -0.202733 0.241187 0.0 +326 2.65 2.75 101.25 0.255314 0.253769 -0.255148 -0.201128 -0.253738 0.20113 0.0 +327 2.65 2.75 108.75 0.214511 0.222856 -0.214525 -0.121963 -0.222827 0.121965 0.0 +328 2.65 2.75 116.25 0.110921 0.123065 -0.110896 -0.0278056 -0.123096 0.027821 0.0 +329 2.65 2.75 123.75 -0.0119931 0.00216882 0.0119589 0.0508731 -0.00227192 -0.0508543 0.0 +330 2.65 2.75 131.25 -0.119575 -0.104676 0.119555 0.102045 0.10466 -0.10204 0.0 +331 2.65 2.75 138.75 -0.220603 -0.205567 0.220425 0.139953 0.205519 -0.139884 0.0 +332 2.65 2.75 146.25 -0.354901 -0.339963 0.354916 0.191191 0.340301 -0.191375 0.0 +333 2.65 2.75 153.75 -0.553233 -0.537535 0.553233 0.27207 0.537478 -0.272051 0.0 +334 2.65 2.75 161.25 -0.800056 -0.783314 0.80005 0.37528 0.783269 -0.375219 0.0 +335 2.65 2.75 168.75 -1.03362 -1.01636 1.03349 0.473222 1.01637 -0.473237 0.0 +336 2.65 2.75 176.25 -1.17633 -1.15917 1.17626 0.532997 1.15938 -0.533141 0.0 +337 2.65 2.85 3.75 -760.67 -716.576 760.67 16548.2 716.576 -16548.2 0.0 +338 2.65 2.85 11.25 -468.577 -458.252 468.577 5405.79 458.252 -5405.79 0.0 +339 2.65 2.85 18.75 -228.053 -226.497 228.053 1802.81 226.497 -1802.81 0.0 +340 2.65 2.85 26.25 -89.1662 -84.2911 89.1663 523.528 84.2911 -523.528 0.0 +341 2.65 2.85 33.75 -28.2756 -21.661 28.2757 117.98 21.661 -117.98 0.0 +342 2.65 2.85 41.25 -7.65848 -3.29349 7.65854 18.6016 3.29345 -18.6016 0.0 +343 2.65 2.85 48.75 -1.87861 -0.425521 1.87855 1.91342 0.425548 -1.91344 0.0 +344 2.65 2.85 56.25 -0.359414 -0.305329 0.359467 0.0202548 0.305288 -0.0202399 0.0 +345 2.65 2.85 63.75 -0.0454417 -0.184956 0.0452869 -0.276244 0.184875 0.276227 0.0 +346 2.65 2.85 71.25 -0.03328 -0.0799704 0.0333967 -0.292345 0.0799691 0.292342 0.0 +347 2.65 2.85 78.75 0.00639036 -0.0189859 -0.006449 -0.241547 0.0190153 0.241563 0.0 +348 2.65 2.85 86.25 0.102068 0.0661345 -0.102071 -0.222916 -0.0661619 0.222919 0.0 +349 2.65 2.85 93.75 0.188697 0.163968 -0.188721 -0.21219 -0.163988 0.212191 0.0 +350 2.65 2.85 101.25 0.22364 0.220472 -0.223377 -0.175014 -0.220473 0.175017 0.0 +351 2.65 2.85 108.75 0.190707 0.202776 -0.190758 -0.106231 -0.202789 0.106247 0.0 +352 2.65 2.85 116.25 0.101112 0.120884 -0.101059 -0.0239388 -0.120905 0.0239052 0.0 +353 2.65 2.85 123.75 -0.00702613 0.0160528 0.00714713 0.0453335 -0.0161052 -0.0453373 0.0 +354 2.65 2.85 131.25 -0.101648 -0.0781261 0.101387 0.088976 0.0781448 -0.0889832 0.0 +355 2.65 2.85 138.75 -0.188841 -0.166223 0.188892 0.119526 0.166146 -0.119525 0.0 +356 2.65 2.85 146.25 -0.306982 -0.284004 0.307036 0.162419 0.283915 -0.162404 0.0 +357 2.65 2.85 153.75 -0.48517 -0.45968 0.485006 0.233515 0.459501 -0.233437 0.0 +358 2.65 2.85 161.25 -0.709159 -0.680393 0.709041 0.326165 0.680286 -0.32613 0.0 +359 2.65 2.85 168.75 -0.921682 -0.890267 0.921631 0.414752 0.89028 -0.414752 0.0 +360 2.65 2.85 176.25 -1.05193 -1.01912 1.05183 0.468933 1.01918 -0.469002 0.0 +361 2.65 2.95 3.75 -652.979 -606.124 652.978 12075.3 606.124 -12075.3 0.0 +362 2.65 2.95 11.25 -403.824 -399.31 403.824 4765.3 399.31 -4765.3 0.0 +363 2.65 2.95 18.75 -187.153 -198.273 187.153 1631.6 198.273 -1631.6 0.0 +364 2.65 2.95 26.25 -66.1445 -73.0744 66.1444 465.712 73.0744 -465.712 0.0 +365 2.65 2.95 33.75 -17.7622 -18.4285 17.7623 99.7601 18.4285 -99.7601 0.0 +366 2.65 2.95 41.25 -3.98999 -2.7919 3.99011 13.9822 2.7919 -13.9822 0.0 +367 2.65 2.95 48.75 -0.962247 -0.422871 0.962286 1.0033 0.422848 -1.00329 0.0 +368 2.65 2.95 56.25 -0.219175 -0.313473 0.218952 -0.0875255 0.313511 0.0875306 0.0 +369 2.65 2.95 63.75 -0.044678 -0.231589 0.0446919 -0.204831 0.231605 0.204882 0.0 +370 2.65 2.95 71.25 -0.0396615 -0.157633 0.0394157 -0.207168 0.15761 0.207183 0.0 +371 2.65 2.95 78.75 0.000394622 -0.0817809 -0.000419789 -0.190543 0.0817504 0.19052 0.0 +372 2.65 2.95 86.25 0.0846769 0.0240518 -0.0846618 -0.190014 -0.0241096 0.19001 0.0 +373 2.65 2.95 93.75 0.158081 0.12764 -0.157821 -0.180645 -0.127555 0.18064 0.0 +374 2.65 2.95 101.25 0.189421 0.189324 -0.189292 -0.147352 -0.189274 0.147358 0.0 +375 2.65 2.95 108.75 0.164176 0.186927 -0.163977 -0.0895019 -0.186952 0.0894983 0.0 +376 2.65 2.95 116.25 0.0871432 0.125207 -0.0868669 -0.0199561 -0.125352 0.0199732 0.0 +377 2.65 2.95 123.75 -0.0085628 0.0365974 0.00860248 0.0390423 -0.0363033 -0.0391 0.0 +378 2.65 2.95 131.25 -0.0923265 -0.0482959 0.0922008 0.0760854 0.0485513 -0.0762079 0.0 +379 2.65 2.95 138.75 -0.169808 -0.131174 0.169899 0.102608 0.131327 -0.10265 0.0 +380 2.65 2.95 146.25 -0.277395 -0.242796 0.277398 0.141394 0.242783 -0.141344 0.0 +381 2.65 2.95 153.75 -0.440501 -0.407224 0.440757 0.205828 0.407133 -0.205796 0.0 +382 2.65 2.95 161.25 -0.645643 -0.610905 0.6459 0.288976 0.611281 -0.289147 0.0 +383 2.65 2.95 168.75 -0.840165 -0.802999 0.840107 0.367747 0.802858 -0.367578 0.0 +384 2.65 2.95 176.25 -0.958665 -0.920072 0.958486 0.415643 0.920088 -0.415608 0.0 +385 2.65 3.05 3.75 -535.332 -454.934 535.332 8760.56 454.934 -8760.56 0.0 +386 2.65 3.05 11.25 -331.494 -306.561 331.494 3960.52 306.561 -3960.52 0.0 +387 2.65 3.05 18.75 -145.715 -152.648 145.715 1393.82 152.648 -1393.82 0.0 +388 2.65 3.05 26.25 -45.1283 -55.696 45.1283 390.806 55.696 -390.806 0.0 +389 2.65 3.05 33.75 -9.03711 -13.9981 9.03714 79.4908 13.9982 -79.4908 0.0 +390 2.65 3.05 41.25 -1.22467 -2.35412 1.22472 9.98439 2.35415 -9.98442 0.0 +391 2.65 3.05 48.75 -0.350067 -0.498445 0.350201 0.482424 0.498397 -0.482377 0.0 +392 2.65 3.05 56.25 -0.145634 -0.296881 0.145625 -0.138328 0.296866 0.138253 0.0 +393 2.65 3.05 63.75 -0.0512301 -0.23938 0.0510461 -0.169789 0.239391 0.169777 0.0 +394 2.65 3.05 71.25 -0.0475131 -0.216688 0.0475797 -0.14914 0.21666 0.149179 0.0 +395 2.65 3.05 78.75 -0.0100019 -0.142708 0.0103876 -0.145447 0.142686 0.145453 0.0 +396 2.65 3.05 86.25 0.0629653 -0.0219697 -0.0630473 -0.155105 0.0219773 0.155114 0.0 +397 2.65 3.05 93.75 0.12664 0.0897788 -0.12658 -0.148638 -0.0897681 0.148648 0.0 +398 2.65 3.05 101.25 0.15677 0.161102 -0.15675 -0.121208 -0.161149 0.121229 0.0 +399 2.65 3.05 108.75 0.13765 0.175494 -0.137742 -0.0739815 -0.175467 0.0739654 0.0 +400 2.65 3.05 116.25 0.0719305 0.132074 -0.0719425 -0.0160117 -0.13204 0.0159808 0.0 +401 2.65 3.05 123.75 -0.0105205 0.0566312 0.0107171 0.0339816 -0.05635 -0.0341083 0.0 +402 2.65 3.05 131.25 -0.0825435 -0.0218324 0.0823353 0.0659987 0.0216974 -0.0659344 0.0 +403 2.65 3.05 138.75 -0.148847 -0.101917 0.149043 0.0897675 0.101945 -0.0897216 0.0 +404 2.65 3.05 146.25 -0.242919 -0.209388 0.242954 0.124121 0.209336 -0.12419 0.0 +405 2.65 3.05 153.75 -0.386426 -0.362461 0.386542 0.179324 0.362431 -0.179385 0.0 +406 2.65 3.05 161.25 -0.566176 -0.547526 0.566298 0.248855 0.547163 -0.248731 0.0 +407 2.65 3.05 168.75 -0.735042 -0.718844 0.735426 0.313712 0.718869 -0.313772 0.0 +408 2.65 3.05 176.25 -0.837976 -0.822371 0.837847 0.352792 0.822288 -0.352789 0.0 +409 2.65 3.15 3.75 -427.355 -285.2 427.355 6295.52 285.2 -6295.52 0.0 +410 2.65 3.15 11.25 -265.153 -194.02 265.153 3125.25 194.02 -3125.25 0.0 +411 2.65 3.15 18.75 -111.202 -95.1726 111.202 1125.35 95.1726 -1125.35 0.0 +412 2.65 3.15 26.25 -29.6517 -33.3268 29.6517 308.747 33.3268 -308.747 0.0 +413 2.65 3.15 33.75 -3.36664 -8.0325 3.36662 59.3209 8.03251 -59.3209 0.0 +414 2.65 3.15 41.25 0.370119 -1.56003 -0.370195 6.73765 1.55997 -6.73765 0.0 +415 2.65 3.15 48.75 -0.0293352 -0.505394 0.0293329 0.248728 0.505409 -0.248723 0.0 +416 2.65 3.15 56.25 -0.105843 -0.270835 0.105751 -0.145765 0.270743 0.145803 0.0 +417 2.65 3.15 63.75 -0.0513317 -0.246866 0.0514241 -0.147382 0.246878 0.147378 0.0 +418 2.65 3.15 71.25 -0.0501128 -0.275431 0.04993 -0.104001 0.275378 0.10398 0.0 +419 2.65 3.15 78.75 -0.0164568 -0.206434 0.0163659 -0.104649 0.206543 0.1047 0.0 +420 2.65 3.15 86.25 0.0461547 -0.0733023 -0.0462363 -0.11996 0.0733698 0.119964 0.0 +421 2.65 3.15 93.75 0.0990004 0.0476562 -0.0990613 -0.115936 -0.0477138 0.115929 0.0 +422 2.65 3.15 101.25 0.124404 0.129396 -0.124624 -0.0943304 -0.129428 0.0943415 0.0 +423 2.65 3.15 108.75 0.110989 0.159191 -0.110618 -0.0576564 -0.159015 0.0576196 0.0 +424 2.65 3.15 116.25 0.0587243 0.132639 -0.0587968 -0.0121644 -0.132721 0.0121638 0.0 +425 2.65 3.15 123.75 -0.00573936 0.071577 0.00545961 0.0272095 -0.0714379 -0.0272703 0.0 +426 2.65 3.15 131.25 -0.0595329 0.00372402 0.0596701 0.0523942 -0.00377444 -0.0523371 0.0 +427 2.65 3.15 138.75 -0.110101 -0.0680458 0.109914 0.0711533 0.0677435 -0.071079 0.0 +428 2.65 3.15 146.25 -0.183484 -0.162436 0.183193 0.097899 0.16187 -0.0976014 0.0 +429 2.65 3.15 153.75 -0.297201 -0.294331 0.297328 0.13994 0.294371 -0.13996 0.0 +430 2.65 3.15 161.25 -0.440022 -0.45053 0.440364 0.191997 0.45081 -0.192128 0.0 +431 2.65 3.15 168.75 -0.573979 -0.593135 0.574118 0.23999 0.593252 -0.240079 0.0 +432 2.65 3.15 176.25 -0.655332 -0.678506 0.655274 0.268714 0.678407 -0.2687 0.0 +433 2.65 3.25 3.75 -343.28 -124.107 343.28 4445.63 124.107 -4445.63 0.0 +434 2.65 3.25 11.25 -215.576 -82.5722 215.576 2350.25 82.5722 -2350.25 0.0 +435 2.65 3.25 18.75 -89.1611 -36.9434 89.1611 858.678 36.9434 -858.678 0.0 +436 2.65 3.25 26.25 -21.9322 -10.3742 21.9323 228.574 10.3742 -228.574 0.0 +437 2.65 3.25 33.75 -1.31403 -1.72106 1.31403 40.8621 1.72107 -40.8621 0.0 +438 2.65 3.25 41.25 0.795648 -0.575902 -0.795697 4.14894 0.57591 -4.14896 0.0 +439 2.65 3.25 48.75 0.0763357 -0.456169 -0.076398 0.148004 0.456256 -0.148065 0.0 +440 2.65 3.25 56.25 -0.063689 -0.249401 0.0637021 -0.13222 0.249531 0.132205 0.0 +441 2.65 3.25 63.75 -0.0358554 -0.249745 0.0359111 -0.121502 0.249724 0.121491 0.0 +442 2.65 3.25 71.25 -0.0428349 -0.311738 0.0428194 -0.0638131 0.311734 0.0637754 0.0 +443 2.65 3.25 78.75 -0.0147141 -0.250034 0.0144509 -0.0678206 0.250075 0.0677768 0.0 +444 2.65 3.25 86.25 0.0352991 -0.11503 -0.0353655 -0.0843742 0.115078 0.0843892 0.0 +445 2.65 3.25 93.75 0.0720144 0.00909964 -0.0719435 -0.0804605 -0.0090581 0.0804531 0.0 +446 2.65 3.25 101.25 0.0888655 0.0989902 -0.0887325 -0.0647524 -0.0990223 0.0647474 0.0 +447 2.65 3.25 108.75 0.0799171 0.143831 -0.0801351 -0.0405357 -0.143865 0.0405626 0.0 +448 2.65 3.25 116.25 0.0463151 0.13551 -0.0462271 -0.0103342 -0.135713 0.0104217 0.0 +449 2.65 3.25 123.75 0.00341445 0.0908375 -0.00340467 0.0161085 -0.0908948 -0.0161034 0.0 +450 2.65 3.25 131.25 -0.0328772 0.0354199 0.0327234 0.0332693 -0.0353895 -0.0333584 0.0 +451 2.65 3.25 138.75 -0.0675007 -0.0244596 0.0674606 0.0466046 0.0245277 -0.0466162 0.0 +452 2.65 3.25 146.25 -0.119973 -0.102745 0.119865 0.0658272 0.102678 -0.0658241 0.0 +453 2.65 3.25 153.75 -0.201674 -0.208813 0.202075 0.0954721 0.209073 -0.0955902 0.0 +454 2.65 3.25 161.25 -0.304347 -0.332116 0.304539 0.131641 0.332258 -0.131649 0.0 +455 2.65 3.25 168.75 -0.400265 -0.443353 0.400058 0.164689 0.443498 -0.164816 0.0 +456 2.65 3.25 176.25 -0.458148 -0.509414 0.458013 0.184384 0.509501 -0.184446 0.0 +457 2.65 3.35 3.75 -278.227 3.35188 278.227 2946.21 -3.35188 -2946.21 0.0 +458 2.65 3.35 11.25 -180.202 7.30679 180.202 1622.2 -7.30679 -1622.2 0.0 +459 2.65 3.35 18.75 -77.9402 10.1339 77.9402 594.724 -10.1339 -594.724 0.0 +460 2.65 3.35 26.25 -20.9467 8.02501 20.9466 151.361 -8.02502 -151.361 0.0 +461 2.65 3.35 33.75 -2.25835 3.3951 2.25826 24.3523 -3.39512 -24.3522 0.0 +462 2.65 3.35 41.25 0.363524 0.335418 -0.363448 2.07799 -0.335341 -2.07804 0.0 +463 2.65 3.35 48.75 0.0599237 -0.367988 -0.059957 0.0931953 0.367953 -0.0931855 0.0 +464 2.65 3.35 56.25 -0.0236982 -0.242143 0.0236458 -0.098598 0.242167 0.0985908 0.0 +465 2.65 3.35 63.75 -0.0239201 -0.250568 0.023879 -0.0793347 0.250659 0.0793004 0.0 +466 2.65 3.35 71.25 -0.0368509 -0.319915 0.0367806 -0.0239745 0.319926 0.0239988 0.0 +467 2.65 3.35 78.75 -0.0110244 -0.268487 0.0110139 -0.0344337 0.268438 0.0344165 0.0 +468 2.65 3.35 86.25 0.0245226 -0.144794 -0.024666 -0.0497857 0.144602 0.0497966 0.0 +469 2.65 3.35 93.75 0.0424081 -0.0251599 -0.0424651 -0.0453306 0.0251858 0.0453233 0.0 +470 2.65 3.35 101.25 0.04903 0.0707895 -0.0493151 -0.0359067 -0.0707318 0.0358776 0.0 +471 2.65 3.35 108.75 0.0471092 0.130164 -0.0471373 -0.0244748 -0.130189 0.0244837 0.0 +472 2.65 3.35 116.25 0.0314376 0.139837 -0.0314698 -0.00916072 -0.139805 0.00913728 0.0 +473 2.65 3.35 123.75 0.00660309 0.109671 -0.00661976 0.00590828 -0.109418 -0.00599612 0.0 +474 2.65 3.35 131.25 -0.0184331 0.0620534 0.0189306 0.0173272 -0.0619207 -0.0174002 0.0 +475 2.65 3.35 138.75 -0.0453275 0.00760214 0.0452428 0.0275525 -0.00734601 -0.027681 0.0 +476 2.65 3.35 146.25 -0.082266 -0.0599492 0.082171 0.0416578 0.0599927 -0.0416724 0.0 +477 2.65 3.35 153.75 -0.136274 -0.146184 0.136402 0.0620795 0.146055 -0.0619743 0.0 +478 2.65 3.35 161.25 -0.202661 -0.24297 0.20278 0.086379 0.243041 -0.0864087 0.0 +479 2.65 3.35 168.75 -0.264667 -0.328848 0.264622 0.108466 0.328816 -0.108439 0.0 +480 2.65 3.35 176.25 -0.302166 -0.379469 0.302333 0.121649 0.379451 -0.121585 0.0 +481 2.65 3.45 3.75 -181.094 56.5768 181.094 1415.07 -56.5768 -1415.07 0.0 +482 2.65 3.45 11.25 -122.646 43.7184 122.646 798.081 -43.7184 -798.081 0.0 +483 2.65 3.45 18.75 -57.6293 27.3547 57.6292 289.903 -27.3547 -289.903 0.0 +484 2.65 3.45 26.25 -18.2701 13.6208 18.2701 69.1213 -13.6207 -69.1213 0.0 +485 2.65 3.45 33.75 -3.43227 4.75555 3.43223 9.49818 -4.75554 -9.49816 0.0 +486 2.65 3.45 41.25 -0.262119 0.743592 0.262138 0.642703 -0.743569 -0.64265 0.0 +487 2.65 3.45 48.75 -0.0206249 -0.220801 0.0206949 0.0833427 0.220803 -0.0833703 0.0 +488 2.65 3.45 56.25 -0.0278092 -0.219147 0.0277268 -0.0418895 0.219207 0.0419362 0.0 +489 2.65 3.45 63.75 -0.0302865 -0.221675 0.0303371 -0.0292143 0.221725 0.0292088 0.0 +490 2.65 3.45 71.25 -0.0283973 -0.257992 0.0284536 0.00362643 0.257937 -0.00359012 0.0 +491 2.65 3.45 78.75 -0.00583895 -0.217814 0.00603552 -0.0105431 0.217741 0.0105389 0.0 +492 2.65 3.45 86.25 0.0119324 -0.129526 -0.0119649 -0.0224338 0.129557 0.0224452 0.0 +493 2.65 3.45 93.75 0.0144366 -0.0428903 -0.0145475 -0.0187179 0.0429014 0.0187299 0.0 +494 2.65 3.45 101.25 0.0149629 0.0297917 -0.015042 -0.0130715 -0.0298841 0.013074 0.0 +495 2.65 3.45 108.75 0.0176727 0.0802808 -0.0176481 -0.00859687 -0.0801128 0.00854075 0.0 +496 2.65 3.45 116.25 0.0142801 0.0968509 -0.0142142 -0.00275531 -0.0968446 0.00279613 0.0 +497 2.65 3.45 123.75 0.00274599 0.0822463 -0.00285046 0.00385754 -0.0822624 -0.00387098 0.0 +498 2.65 3.45 131.25 -0.0115459 0.0508246 0.0116421 0.00941126 -0.0506893 -0.00950556 0.0 +499 2.65 3.45 138.75 -0.0256544 0.0123774 0.0254092 0.0140698 -0.0124329 -0.0139752 0.0 +500 2.65 3.45 146.25 -0.0416502 -0.0338945 0.0416358 0.0199093 0.0339039 -0.0199382 0.0 +501 2.65 3.45 153.75 -0.06548 -0.0902951 0.0654101 0.02876 0.0902214 -0.0286754 0.0 +502 2.65 3.45 161.25 -0.0968618 -0.152516 0.096841 0.0402396 0.152761 -0.0403307 0.0 +503 2.65 3.45 168.75 -0.128132 -0.207768 0.128088 0.0514288 0.207796 -0.0514167 0.0 +504 2.65 3.45 176.25 -0.147889 -0.240577 0.147879 0.058392 0.24052 -0.0584226 0.0 +505 2.65 3.55 3.75 -77.1979 33.0526 77.1979 408.269 -33.0526 -408.269 0.0 +506 2.65 3.55 11.25 -54.4456 24.806 54.4456 233.071 -24.806 -233.071 0.0 +507 2.65 3.55 18.75 -27.4729 14.6982 27.4729 83.0823 -14.6982 -83.0823 0.0 +508 2.65 3.55 26.25 -9.74029 6.98034 9.74028 18.3878 -6.98034 -18.3878 0.0 +509 2.65 3.55 33.75 -2.26688 2.44976 2.26686 2.2212 -2.44975 -2.22122 0.0 +510 2.65 3.55 41.25 -0.338901 0.452784 0.338876 0.250018 -0.452783 -0.250042 0.0 +511 2.65 3.55 48.75 -0.085801 -0.0837087 0.0858276 0.0833161 0.0837009 -0.0833153 0.0 +512 2.65 3.55 56.25 -0.053787 -0.114074 0.0537453 -0.0208865 0.114083 0.0208809 0.0 +513 2.65 3.55 63.75 -0.0249841 -0.102636 0.0249818 -0.0169731 0.102618 0.0169814 0.0 +514 2.65 3.55 71.25 -0.00793484 -0.104993 0.0079199 0.00243536 0.104968 -0.00244121 0.0 +515 2.65 3.55 78.75 0.000477289 -0.083635 -0.000473373 -0.0028304 0.083634 0.00283354 0.0 +516 2.65 3.55 86.25 0.00225691 -0.0484377 -0.00227501 -0.00865479 0.0484012 0.00865592 0.0 +517 2.65 3.55 93.75 0.00072074 -0.0198074 -0.000659016 -0.00641186 0.0197662 0.00641637 0.0 +518 2.65 3.55 101.25 0.00112223 0.00094823 -0.0011259 -0.00217623 -0.000927796 0.00217226 0.0 +519 2.65 3.55 108.75 0.00303859 0.0169456 -0.0030474 0.000636489 -0.0170012 -0.000616911 0.0 +520 2.65 3.55 116.25 0.00293939 0.0254903 -0.00299498 0.00226534 -0.0254881 -0.00227427 0.0 +521 2.65 3.55 123.75 0.00105767 0.0250956 -0.00100249 0.00302411 -0.0251043 -0.00302286 0.0 +522 2.65 3.55 131.25 0.00089622 0.018822 -0.000861732 0.00254531 -0.0188028 -0.00256904 0.0 +523 2.65 3.55 138.75 0.00382565 0.0100627 -0.0038702 0.000936262 -0.0101195 -0.000921113 0.0 +524 2.65 3.55 146.25 0.00637878 -0.00112474 -0.0063611 -0.000499545 0.00116119 0.000462636 0.0 +525 2.65 3.55 153.75 0.00342379 -0.0163538 -0.00340327 -0.0001089 0.0163686 9.31942e-05 0.0 +526 2.65 3.55 161.25 -0.0063525 -0.0350349 0.00642576 0.00261085 0.0350954 -0.00266173 0.0 +527 2.65 3.55 168.75 -0.0193118 -0.0529521 0.01932 0.00641632 0.0530167 -0.00647477 0.0 +528 2.65 3.55 176.25 -0.0282729 -0.0640227 0.0283342 0.00913184 0.0640796 -0.00915341 0.0 +529 2.65 3.65 3.75 -9.07399 3.23181 9.07399 31.5979 -3.23181 -31.5979 0.0 +530 2.65 3.65 11.25 -6.54957 2.36668 6.54957 18.1922 -2.36668 -18.1922 0.0 +531 2.65 3.65 18.75 -3.41782 1.35636 3.41782 6.44075 -1.35636 -6.44075 0.0 +532 2.65 3.65 26.25 -1.25794 0.63761 1.25794 1.4388 -0.63761 -1.4388 0.0 +533 2.65 3.65 33.75 -0.314954 0.229217 0.314955 0.252105 -0.229219 -0.252103 0.0 +534 2.65 3.65 41.25 -0.0703285 0.0433984 0.0703295 0.0804037 -0.0433987 -0.080406 0.0 +535 2.65 3.65 48.75 -0.0346923 -0.00594178 0.0346905 0.0178914 0.00594136 -0.0178931 0.0 +536 2.65 3.65 56.25 -0.0178793 -0.00218658 0.0178826 -0.0109585 0.00218474 0.0109613 0.0 +537 2.65 3.65 63.75 -0.00296649 0.00371443 0.00296685 -0.0077863 -0.00371456 0.00778602 0.0 +538 2.65 3.65 71.25 0.00156936 0.00391538 -0.00157049 -0.000554586 -0.00391343 0.000556069 0.0 +539 2.65 3.65 78.75 4.72839e-05 0.00437901 -5.76159e-05 0.000766606 -0.00437852 -0.000767667 0.0 +540 2.65 3.65 86.25 -0.00150151 0.00465743 0.00150145 4.48359e-05 -0.00465746 -4.47759e-05 0.0 +541 2.65 3.65 93.75 -0.00154911 0.0023728 0.00155712 3.94444e-05 -0.00237267 -3.93568e-05 0.0 +542 2.65 3.65 101.25 -0.00102647 -0.00107232 0.0010322 0.000455843 0.00107411 -0.000456348 0.0 +543 2.65 3.65 108.75 -0.000931385 -0.00331098 0.000926423 0.000617065 0.00331642 -0.000619741 0.0 +544 2.65 3.65 116.25 -0.00125989 -0.00405896 0.00125662 0.000489735 0.00405917 -0.000489051 0.0 +545 2.65 3.65 123.75 -0.00119027 -0.00416793 0.00118127 0.00025776 0.00417216 -0.000258364 0.0 +546 2.65 3.65 131.25 2.02558e-06 -0.00385544 9.97877e-07 -5.65576e-05 0.00385538 5.6561e-05 0.0 +547 2.65 3.65 138.75 0.0019471 -0.0027434 -0.00193851 -0.000439961 0.00274576 0.000440451 0.0 +548 2.65 3.65 146.25 0.00340728 -0.000754999 -0.00340313 -0.000680537 0.000762165 0.000677165 0.0 +549 2.65 3.65 153.75 0.00324508 0.00162334 -0.00324525 -0.000497576 -0.00162245 0.000496814 0.0 +550 2.65 3.65 161.25 0.00132741 0.00369896 -0.00132849 0.000164919 -0.00371082 -0.000158918 0.0 +551 2.65 3.65 168.75 -0.00130947 0.00507786 0.00131187 0.00102227 -0.00507988 -0.00102051 0.0 +552 2.65 3.65 176.25 -0.00317672 0.00571563 0.00316942 0.00161776 -0.00571614 -0.00161842 0.0 +553 2.75 2.75 3.75 -953.112 -854.306 953.112 25981 854.306 -25981 0.0 +554 2.75 2.75 11.25 -539.051 -520.941 539.051 5855.95 520.941 -5855.95 0.0 +555 2.75 2.75 18.75 -242.983 -254.204 242.983 1824.66 254.204 -1824.66 0.0 +556 2.75 2.75 26.25 -83.2573 -94.4794 83.2573 502.272 94.4793 -502.272 0.0 +557 2.75 2.75 33.75 -20.5412 -24.7823 20.5412 104.828 24.7823 -104.828 0.0 +558 2.75 2.75 41.25 -3.9136 -4.29412 3.91362 14.9464 4.2941 -14.9465 0.0 +559 2.75 2.75 48.75 -1.12328 -0.873619 1.12322 1.93019 0.873624 -1.93018 0.0 +560 2.75 2.75 56.25 -0.514324 -0.496154 0.514312 0.391368 0.496221 -0.39134 0.0 +561 2.75 2.75 63.75 -0.164596 -0.213443 0.164691 -0.208447 0.213484 0.208481 0.0 +562 2.75 2.75 71.25 -0.041967 -0.0485499 0.0420123 -0.328452 0.0485135 0.328445 0.0 +563 2.75 2.75 78.75 0.00770861 0.0144404 -0.0076428 -0.256255 -0.0144125 0.25625 0.0 +564 2.75 2.75 86.25 0.090797 0.0907928 -0.090835 -0.225168 -0.0907865 0.225168 0.0 +565 2.75 2.75 93.75 0.181978 0.179759 -0.182045 -0.218388 -0.179673 0.218388 0.0 +566 2.75 2.75 101.25 0.225859 0.223811 -0.2259 -0.17996 -0.22375 0.17996 0.0 +567 2.75 2.75 108.75 0.197221 0.193022 -0.197213 -0.105534 -0.19316 0.105561 0.0 +568 2.75 2.75 116.25 0.109362 0.103419 -0.109316 -0.0211263 -0.10351 0.0211473 0.0 +569 2.75 2.75 123.75 0.00356169 -0.00337669 -0.00365545 0.0468134 0.00343037 -0.0468135 0.0 +570 2.75 2.75 131.25 -0.0899181 -0.097849 0.0896843 0.0904862 0.0978568 -0.090473 0.0 +571 2.75 2.75 138.75 -0.180752 -0.189165 0.180483 0.124806 0.189251 -0.124873 0.0 +572 2.75 2.75 146.25 -0.307245 -0.315227 0.307006 0.173842 0.315177 -0.173832 0.0 +573 2.75 2.75 153.75 -0.495888 -0.504071 0.495883 0.250885 0.504047 -0.250882 0.0 +574 2.75 2.75 161.25 -0.730452 -0.740638 0.730449 0.347741 0.740677 -0.347784 0.0 +575 2.75 2.75 168.75 -0.951281 -0.965256 0.9512 0.438629 0.965085 -0.438584 0.0 +576 2.75 2.75 176.25 -1.08583 -1.10279 1.08592 0.493743 1.10285 -0.493793 0.0 +577 2.75 2.85 3.75 -970.563 -775.744 970.563 23153.2 775.744 -23153.2 0.0 +578 2.75 2.85 11.25 -556.721 -474.097 556.721 5862.74 474.097 -5862.74 0.0 +579 2.75 2.85 18.75 -250.751 -224.584 250.751 1827.2 224.584 -1827.2 0.0 +580 2.75 2.85 26.25 -86.059 -77.5526 86.059 494.052 77.5526 -494.052 0.0 +581 2.75 2.85 33.75 -21.7848 -16.8577 21.7848 99.2767 16.8577 -99.2767 0.0 +582 2.75 2.85 41.25 -4.50961 -1.52272 4.5095 12.9376 1.52274 -12.9376 0.0 +583 2.75 2.85 48.75 -1.25065 -0.243785 1.25071 1.39261 0.243763 -1.39263 0.0 +584 2.75 2.85 56.25 -0.463066 -0.460087 0.463015 0.300113 0.460075 -0.300136 0.0 +585 2.75 2.85 63.75 -0.151187 -0.275288 0.151132 -0.144808 0.275348 0.144857 0.0 +586 2.75 2.85 71.25 -0.0749749 -0.110892 0.0749169 -0.249281 0.110829 0.249264 0.0 +587 2.75 2.85 78.75 -0.0201116 -0.0351113 0.0202283 -0.210984 0.0351362 0.210976 0.0 +588 2.75 2.85 86.25 0.0736389 0.0501401 -0.0736054 -0.194737 -0.0502144 0.194733 0.0 +589 2.75 2.85 93.75 0.160078 0.146192 -0.159898 -0.1879 -0.146241 0.187904 0.0 +590 2.75 2.85 101.25 0.200786 0.204303 -0.200728 -0.156391 -0.204259 0.156374 0.0 +591 2.75 2.85 108.75 0.17997 0.193028 -0.179585 -0.0955768 -0.192919 0.0955569 0.0 +592 2.75 2.85 116.25 0.103624 0.119278 -0.103941 -0.0221991 -0.119219 0.0221951 0.0 +593 2.75 2.85 123.75 0.00644177 0.0211333 -0.00659697 0.0394802 -0.0210367 -0.0394978 0.0 +594 2.75 2.85 131.25 -0.0803186 -0.0672129 0.080414 0.0781492 0.0671178 -0.0781413 0.0 +595 2.75 2.85 138.75 -0.161637 -0.148838 0.161505 0.105436 0.149111 -0.105534 0.0 +596 2.75 2.85 146.25 -0.270086 -0.257695 0.270083 0.14428 0.257823 -0.144344 0.0 +597 2.75 2.85 153.75 -0.43239 -0.421507 0.432363 0.208547 0.421587 -0.208591 0.0 +598 2.75 2.85 161.25 -0.634898 -0.628455 0.634872 0.291785 0.628448 -0.291789 0.0 +599 2.75 2.85 168.75 -0.826247 -0.825693 0.826352 0.370982 0.825733 -0.37098 0.0 +600 2.75 2.85 176.25 -0.943351 -0.946865 0.943117 0.419282 0.946914 -0.419356 0.0 +601 2.75 2.95 3.75 -897.538 -636.356 897.538 17274.5 636.356 -17274.5 0.0 +602 2.75 2.95 11.25 -527.594 -400.007 527.594 5426.93 400.007 -5426.93 0.0 +603 2.75 2.95 18.75 -234.856 -188.606 234.856 1719.6 188.606 -1719.6 0.0 +604 2.75 2.95 26.25 -78.0109 -63.1924 78.0109 457.632 63.1924 -457.632 0.0 +605 2.75 2.95 33.75 -18.5523 -12.6415 18.5523 88.2261 12.6415 -88.2261 0.0 +606 2.75 2.95 41.25 -3.43241 -0.788747 3.43237 10.3311 0.788758 -10.3311 0.0 +607 2.75 2.95 48.75 -0.834456 -0.199558 0.834517 0.799118 0.199613 -0.799125 0.0 +608 2.75 2.95 56.25 -0.273778 -0.463123 0.273749 0.148104 0.463143 -0.148167 0.0 +609 2.75 2.95 63.75 -0.103413 -0.318818 0.103504 -0.111608 0.31885 0.111645 0.0 +610 2.75 2.95 71.25 -0.0843263 -0.181793 0.0843793 -0.175312 0.181809 0.175287 0.0 +611 2.75 2.95 78.75 -0.0303993 -0.093494 0.0304044 -0.167209 0.0935528 0.167232 0.0 +612 2.75 2.95 86.25 0.0620423 0.00699782 -0.0622995 -0.169543 -0.00683051 0.169553 0.0 +613 2.75 2.95 93.75 0.136614 0.106217 -0.136678 -0.163514 -0.106191 0.163506 0.0 +614 2.75 2.95 101.25 0.17196 0.170249 -0.171903 -0.134812 -0.170364 0.13483 0.0 +615 2.75 2.95 108.75 0.15684 0.174342 -0.156924 -0.0828548 -0.174193 0.082802 0.0 +616 2.75 2.95 116.25 0.0926482 0.118695 -0.0927901 -0.0195911 -0.118646 0.0195826 0.0 +617 2.75 2.95 123.75 0.00849675 0.0355959 -0.00833828 0.0336514 -0.0356652 -0.0336479 0.0 +618 2.75 2.95 131.25 -0.0660839 -0.0418908 0.0662238 0.0659291 0.041797 -0.065883 0.0 +619 2.75 2.95 138.75 -0.134275 -0.114174 0.134106 0.0880437 0.114322 -0.0880806 0.0 +620 2.75 2.95 146.25 -0.227305 -0.21177 0.227027 0.121094 0.2116 -0.121002 0.0 +621 2.75 2.95 153.75 -0.368554 -0.358527 0.368374 0.177219 0.358663 -0.177335 0.0 +622 2.75 2.95 161.25 -0.546482 -0.542986 0.546711 0.250148 0.542877 -0.250051 0.0 +623 2.75 2.95 168.75 -0.715439 -0.717898 0.715379 0.319323 0.717937 -0.319304 0.0 +624 2.75 2.95 176.25 -0.817997 -0.824689 0.818295 0.361371 0.825027 -0.361574 0.0 +625 2.75 3.05 3.75 -770.161 -463.434 770.161 12393.7 463.434 -12393.7 0.0 +626 2.75 3.05 11.25 -462.237 -301.474 462.237 4693.99 301.474 -4693.99 0.0 +627 2.75 3.05 18.75 -201.495 -143.479 201.495 1525.17 143.479 -1525.17 0.0 +628 2.75 3.05 26.25 -62.9238 -47.8688 62.9238 399.794 47.8688 -399.794 0.0 +629 2.75 3.05 33.75 -12.9682 -9.61891 12.9682 73.8547 9.61892 -73.8547 0.0 +630 2.75 3.05 41.25 -1.7583 -0.85457 1.75829 7.81837 0.854518 -7.81834 0.0 +631 2.75 3.05 48.75 -0.381642 -0.346117 0.381587 0.40516 0.34605 -0.405176 0.0 +632 2.75 3.05 56.25 -0.163641 -0.440252 0.163583 0.0381865 0.440156 -0.0381959 0.0 +633 2.75 3.05 63.75 -0.103568 -0.332346 0.103485 -0.0833787 0.332372 0.0833554 0.0 +634 2.75 3.05 71.25 -0.101444 -0.24461 0.101602 -0.107568 0.244525 0.107546 0.0 +635 2.75 3.05 78.75 -0.038508 -0.1504 0.038783 -0.1224 0.150253 0.122395 0.0 +636 2.75 3.05 86.25 0.0496984 -0.0343332 -0.0494439 -0.140095 0.0345932 0.140101 0.0 +637 2.75 3.05 93.75 0.111297 0.06995 -0.111612 -0.135869 -0.0701637 0.135882 0.0 +638 2.75 3.05 101.25 0.140426 0.140943 -0.140275 -0.110396 -0.140778 0.110407 0.0 +639 2.75 3.05 108.75 0.12795 0.158778 -0.128322 -0.0664922 -0.158818 0.0664985 0.0 +640 2.75 3.05 116.25 0.0728381 0.119891 -0.0730793 -0.0130873 -0.11982 0.0129934 0.0 +641 2.75 3.05 123.75 0.000267345 0.0511317 -9.01598e-05 0.0314953 -0.0510922 -0.03149 0.0 +642 2.75 3.05 131.25 -0.063069 -0.0174406 0.0628665 0.0580034 0.0170276 -0.0579042 0.0 +643 2.75 3.05 138.75 -0.119018 -0.0842153 0.11903 0.0763319 0.0841315 -0.0762935 0.0 +644 2.75 3.05 146.25 -0.197865 -0.1752 0.197467 0.104414 0.175196 -0.104295 0.0 +645 2.75 3.05 153.75 -0.319615 -0.309756 0.319424 0.151665 0.309809 -0.15167 0.0 +646 2.75 3.05 161.25 -0.473103 -0.474577 0.47295 0.212121 0.474601 -0.212138 0.0 +647 2.75 3.05 168.75 -0.617392 -0.628077 0.617611 0.268756 0.627819 -0.268631 0.0 +648 2.75 3.05 176.25 -0.705354 -0.720636 0.705297 0.302934 0.720794 -0.303013 0.0 +649 2.75 3.15 3.75 -621.059 -283.307 621.059 8818.58 283.307 -8818.58 0.0 +650 2.75 3.15 11.25 -378.076 -190.869 378.076 3830.09 190.869 -3830.09 0.0 +651 2.75 3.15 18.75 -160.427 -92.3481 160.427 1277.7 92.3481 -1277.7 0.0 +652 2.75 3.15 26.25 -45.9966 -30.9532 45.9966 329.373 30.9532 -329.373 0.0 +653 2.75 3.15 33.75 -7.4094 -6.49374 7.40945 58.1344 6.49371 -58.1344 0.0 +654 2.75 3.15 41.25 -0.360268 -0.948504 0.360207 5.64912 0.948525 -5.64911 0.0 +655 2.75 3.15 48.75 -0.109681 -0.454359 0.109583 0.215632 0.454311 -0.215651 0.0 +656 2.75 3.15 56.25 -0.128581 -0.381055 0.12849 -0.024614 0.380998 0.0245607 0.0 +657 2.75 3.15 63.75 -0.107772 -0.325095 0.107852 -0.0656164 0.325178 0.0656213 0.0 +658 2.75 3.15 71.25 -0.10009 -0.293719 0.100061 -0.059479 0.293753 0.059475 0.0 +659 2.75 3.15 78.75 -0.036158 -0.200438 0.0358502 -0.0856231 0.200546 0.0856524 0.0 +660 2.75 3.15 86.25 0.0377439 -0.0742392 -0.037571 -0.109183 0.0742289 0.109172 0.0 +661 2.75 3.15 93.75 0.0838315 0.0343987 -0.0838656 -0.104987 -0.0344864 0.105012 0.0 +662 2.75 3.15 101.25 0.106057 0.110494 -0.106108 -0.0834801 -0.110598 0.0834927 0.0 +663 2.75 3.15 108.75 0.0968552 0.139813 -0.0967877 -0.0483794 -0.139765 0.0483448 0.0 +664 2.75 3.15 116.25 0.051391 0.115917 -0.0515763 -0.0060004 -0.116112 0.00610288 0.0 +665 2.75 3.15 123.75 -0.00713598 0.0613642 0.00718246 0.0286098 -0.0614779 -0.0285439 0.0 +666 2.75 3.15 131.25 -0.0559847 0.00396885 0.0560961 0.0483465 -0.00390007 -0.0484359 0.0 +667 2.75 3.15 138.75 -0.0990609 -0.0545791 0.0984659 0.061732 0.0548182 -0.0618343 0.0 +668 2.75 3.15 146.25 -0.159454 -0.134936 0.1595 0.0827794 0.135061 -0.08272 0.0 +669 2.75 3.15 153.75 -0.25524 -0.251075 0.255086 0.118141 0.251122 -0.118172 0.0 +670 2.75 3.15 161.25 -0.375288 -0.38964 0.375663 0.162894 0.389747 -0.16293 0.0 +671 2.75 3.15 168.75 -0.488486 -0.516392 0.488643 0.204424 0.516148 -0.204273 0.0 +672 2.75 3.15 176.25 -0.556839 -0.591689 0.556911 0.229329 0.591767 -0.229304 0.0 +673 2.75 3.25 3.75 -476.667 -121.19 476.667 6210.58 121.19 -6210.58 0.0 +674 2.75 3.25 11.25 -293.373 -85.8334 293.373 2968.1 85.8334 -2968.1 0.0 +675 2.75 3.25 18.75 -121.508 -42.7495 121.508 1012.27 42.7495 -1012.27 0.0 +676 2.75 3.25 26.25 -31.8786 -14.325 31.8786 255.334 14.325 -255.334 0.0 +677 2.75 3.25 33.75 -3.63288 -3.16546 3.63301 42.6516 3.16544 -42.6516 0.0 +678 2.75 3.25 41.25 0.315726 -0.793557 -0.315791 3.80727 0.79365 -3.8073 0.0 +679 2.75 3.25 48.75 -0.0242544 -0.460584 0.0242178 0.130581 0.460619 -0.130536 0.0 +680 2.75 3.25 56.25 -0.0991531 -0.30838 0.0992679 -0.0606306 0.308269 0.0605918 0.0 +681 2.75 3.25 63.75 -0.0775749 -0.303078 0.0775341 -0.058713 0.303134 0.0587059 0.0 +682 2.75 3.25 71.25 -0.0726081 -0.316404 0.0725509 -0.0320203 0.316355 0.0321083 0.0 +683 2.75 3.25 78.75 -0.0250871 -0.232854 0.0249036 -0.0576022 0.232759 0.0576201 0.0 +684 2.75 3.25 86.25 0.0262879 -0.108161 -0.0264355 -0.0771184 0.108011 0.0771155 0.0 +685 2.75 3.25 93.75 0.0560476 -0.000207024 -0.0559883 -0.0716051 0.000146475 0.0716155 0.0 +686 2.75 3.25 101.25 0.072468 0.0806321 -0.0723149 -0.0559611 -0.0805163 0.0559016 0.0 +687 2.75 3.25 108.75 0.0683282 0.121003 -0.068317 -0.0319853 -0.121 0.0319423 0.0 +688 2.75 3.25 116.25 0.0376756 0.112607 -0.037291 -0.00283035 -0.112703 0.00284452 0.0 +689 2.75 3.25 123.75 -0.00470402 0.0730337 0.00443815 0.0205484 -0.072994 -0.0206443 0.0 +690 2.75 3.25 131.25 -0.0393657 0.0275953 0.0393646 0.0333389 -0.02763 -0.0332308 0.0 +691 2.75 3.25 138.75 -0.0690594 -0.0208708 0.0692442 0.0419952 0.0207699 -0.0419967 0.0 +692 2.75 3.25 146.25 -0.111014 -0.0862657 0.110952 0.0560987 0.0863438 -0.0561322 0.0 +693 2.75 3.25 153.75 -0.176809 -0.178443 0.176496 0.0798216 0.178512 -0.0798746 0.0 +694 2.75 3.25 161.25 -0.258767 -0.286055 0.259122 0.109635 0.286421 -0.109773 0.0 +695 2.75 3.25 168.75 -0.336709 -0.383242 0.3365 0.137155 0.383371 -0.137249 0.0 +696 2.75 3.25 176.25 -0.383233 -0.440518 0.383304 0.153612 0.440294 -0.153402 0.0 +697 2.75 3.35 3.75 -341.385 1.74756 341.385 4134.74 -1.74757 -4134.74 0.0 +698 2.75 3.35 11.25 -213.168 -3.19693 213.168 2109.24 3.19691 -2109.24 0.0 +699 2.75 3.35 18.75 -87.8275 -2.99417 87.8276 729.622 2.99416 -729.622 0.0 +700 2.75 3.35 26.25 -22.0888 -0.704944 22.0887 178.369 0.70499 -178.369 0.0 +701 2.75 3.35 33.75 -2.07542 -0.0682655 2.0755 27.6089 0.0682662 -27.6089 0.0 +702 2.75 3.35 41.25 0.300247 -0.350456 -0.300305 2.18926 0.350473 -2.18927 0.0 +703 2.75 3.35 48.75 -0.0373785 -0.369541 0.0374118 0.0833796 0.36958 -0.083402 0.0 +704 2.75 3.35 56.25 -0.0518069 -0.259322 0.0517312 -0.0686295 0.259412 0.0687251 0.0 +705 2.75 3.35 63.75 -0.0322367 -0.285586 0.0323754 -0.0471277 0.285461 0.0471608 0.0 +706 2.75 3.35 71.25 -0.0437375 -0.317171 0.043788 -0.0133265 0.317084 0.0133532 0.0 +707 2.75 3.35 78.75 -0.0172441 -0.248737 0.0171536 -0.0330689 0.248747 0.0330618 0.0 +708 2.75 3.35 86.25 0.0144849 -0.135178 -0.014571 -0.0452186 0.135353 0.0452189 0.0 +709 2.75 3.35 93.75 0.030471 -0.0300865 -0.030347 -0.0398041 0.0300945 0.0397911 0.0 +710 2.75 3.35 101.25 0.0406014 0.0563913 -0.0407253 -0.0312837 -0.0564639 0.0312859 0.0 +711 2.75 3.35 108.75 0.0422766 0.108893 -0.0423538 -0.0189637 -0.109138 0.0190212 0.0 +712 2.75 3.35 116.25 0.0267588 0.115186 -0.0269597 -0.00297617 -0.11525 0.00295127 0.0 +713 2.75 3.35 123.75 0.000501099 0.0878862 -0.000774694 0.0104498 -0.0881349 -0.0102325 0.0 +714 2.75 3.35 131.25 -0.0236225 0.0489236 0.0238085 0.0185255 -0.0490552 -0.0184822 0.0 +715 2.75 3.35 138.75 -0.0444452 0.00629968 0.044223 0.0246731 -0.00652667 -0.0245664 0.0 +716 2.75 3.35 146.25 -0.0693381 -0.0474412 0.069485 0.0339103 0.0474594 -0.0339419 0.0 +717 2.75 3.35 153.75 -0.107186 -0.118947 0.107138 0.0484857 0.1189 -0.0484203 0.0 +718 2.75 3.35 161.25 -0.154793 -0.200912 0.154723 0.0665572 0.200588 -0.0663788 0.0 +719 2.75 3.35 168.75 -0.200583 -0.274251 0.200264 0.0833152 0.274149 -0.0833102 0.0 +720 2.75 3.35 176.25 -0.22795 -0.317539 0.228214 0.0934114 0.317615 -0.093522 0.0 +721 2.75 3.45 3.75 -181.602 50.4515 181.602 2007.55 -50.4515 -2007.55 0.0 +722 2.75 3.45 11.25 -116.135 31.353 116.135 1069.23 -31.3531 -1069.23 0.0 +723 2.75 3.45 18.75 -49.1544 14.1197 49.1544 371.433 -14.1197 -371.433 0.0 +724 2.75 3.45 26.25 -12.9027 5.27843 12.9027 86.871 -5.27842 -86.871 0.0 +725 2.75 3.45 33.75 -1.53044 1.58922 1.53042 12.1098 -1.58919 -12.1098 0.0 +726 2.75 3.45 41.25 0.0034182 0.175305 -0.00341175 0.852259 -0.175314 -0.852262 0.0 +727 2.75 3.45 48.75 -0.0627082 -0.187051 0.0626463 0.0745378 0.187162 -0.0745079 0.0 +728 2.75 3.45 56.25 -0.0269175 -0.208615 0.0269865 -0.0380544 0.208565 0.0380413 0.0 +729 2.75 3.45 63.75 -0.0156683 -0.232533 0.0156754 -0.0230666 0.232476 0.0230535 0.0 +730 2.75 3.45 71.25 -0.027083 -0.247837 0.027041 5.30776e-05 0.247723 -0.000124963 0.0 +731 2.75 3.45 78.75 -0.0110419 -0.199747 0.0110237 -0.01275 0.199733 0.0127249 0.0 +732 2.75 3.45 86.25 0.00600723 -0.118375 -0.00584057 -0.01943 0.118327 0.0194294 0.0 +733 2.75 3.45 93.75 0.00873478 -0.0394094 -0.00879205 -0.0152652 0.0394659 0.0152585 0.0 +734 2.75 3.45 101.25 0.00962037 0.0272073 -0.00960224 -0.0103152 -0.0271381 0.0103031 0.0 +735 2.75 3.45 108.75 0.0122306 0.0719369 -0.0122886 -0.00545491 -0.071926 0.00547195 0.0 +736 2.75 3.45 116.25 0.00974245 0.0846866 -0.00979763 -2.00295e-05 -0.084746 5.2625e-05 0.0 +737 2.75 3.45 123.75 0.000243929 0.070346 -0.000352399 0.00484904 -0.0702929 -0.00489636 0.0 +738 2.75 3.45 131.25 -0.010453 0.043801 0.0102586 0.00831848 -0.0439736 -0.00824598 0.0 +739 2.75 3.45 138.75 -0.0180464 0.0137037 0.0179837 0.0107806 -0.0137201 -0.0108167 0.0 +740 2.75 3.45 146.25 -0.025475 -0.0218772 0.0256088 0.0136926 0.0220646 -0.0138449 0.0 +741 2.75 3.45 153.75 -0.0382383 -0.0672046 0.0382092 0.0186021 0.0672579 -0.018626 0.0 +742 2.75 3.45 161.25 -0.0575259 -0.119353 0.0574959 0.0256839 0.119252 -0.0256513 0.0 +743 2.75 3.45 168.75 -0.0781428 -0.166869 0.078149 0.0330717 0.16689 -0.0331148 0.0 +744 2.75 3.45 176.25 -0.0916728 -0.195518 0.0917779 0.0378401 0.195665 -0.037981 0.0 +745 2.75 3.55 3.75 -60.5153 27.692 60.5153 588.046 -27.692 -588.046 0.0 +746 2.75 3.55 11.25 -39.8784 17.4201 39.8784 321.892 -17.4201 -321.892 0.0 +747 2.75 3.55 18.75 -17.6334 7.7718 17.6334 111.365 -7.7718 -111.365 0.0 +748 2.75 3.55 26.25 -4.94614 2.91047 4.94616 24.801 -2.91047 -24.801 0.0 +749 2.75 3.55 33.75 -0.717862 1.02613 0.717872 3.21211 -1.02616 -3.21209 0.0 +750 2.75 3.55 41.25 -0.0703286 0.253386 0.0703577 0.326292 -0.253389 -0.326305 0.0 +751 2.75 3.55 48.75 -0.0696314 -0.0360868 0.0696098 0.0745468 0.0361057 -0.0745544 0.0 +752 2.75 3.55 56.25 -0.0386849 -0.0894109 0.0386635 -0.0191097 0.0894516 0.0190794 0.0 +753 2.75 3.55 63.75 -0.0158765 -0.0925221 0.0158458 -0.0145167 0.09256 0.0145237 0.0 +754 2.75 3.55 71.25 -0.00997075 -0.0929607 0.00998059 0.000467248 0.0929809 -0.000443377 0.0 +755 2.75 3.55 78.75 -0.00149974 -0.0734939 0.00146198 -0.00355586 0.0735358 0.00355353 0.0 +756 2.75 3.55 86.25 0.0028805 -0.042718 -0.00289025 -0.00634796 0.0427423 0.00634686 0.0 +757 2.75 3.55 93.75 -0.000895397 -0.0173398 0.000915914 -0.00268197 0.0173692 0.00268557 0.0 +758 2.75 3.55 101.25 -0.00461455 0.00200332 0.00464936 0.00177679 -0.00195006 -0.0017874 0.0 +759 2.75 3.55 108.75 -0.00367123 0.0176377 0.00372332 0.00363241 -0.0176972 -0.00361264 0.0 +760 2.75 3.55 116.25 -0.00131124 0.0260317 0.00133193 0.00346321 -0.0260021 -0.00346733 0.0 +761 2.75 3.55 123.75 -0.000257145 0.0251737 0.000204938 0.00292588 -0.0251838 -0.00291469 0.0 +762 2.75 3.55 131.25 0.000973531 0.0188626 -0.000971992 0.00228745 -0.0188196 -0.00232812 0.0 +763 2.75 3.55 138.75 0.00409367 0.011615 -0.00404917 0.000911448 -0.011591 -0.000925473 0.0 +764 2.75 3.55 146.25 0.00744491 0.00348645 -0.0075166 -0.000905243 -0.00344952 0.000869305 0.0 +765 2.75 3.55 153.75 0.00762023 -0.00783196 -0.00763712 -0.00180907 0.00784858 0.00180265 0.0 +766 2.75 3.55 161.25 0.00271034 -0.0229315 -0.00264761 -0.000890015 0.0229401 0.000888095 0.0 +767 2.75 3.55 168.75 -0.0051415 -0.0382675 0.00514139 0.00125874 0.0383533 -0.00131918 0.0 +768 2.75 3.55 176.25 -0.0109249 -0.0480268 0.0109626 0.00300256 0.0480665 -0.00301775 0.0 +769 2.75 3.65 3.75 -5.4585 2.19054 5.4585 46.1523 -2.19054 -46.1523 0.0 +770 2.75 3.65 11.25 -3.66097 1.22096 3.66097 25.7483 -1.22096 -25.7483 0.0 +771 2.75 3.65 18.75 -1.63156 0.409151 1.63156 8.91799 -0.409152 -8.91799 0.0 +772 2.75 3.65 26.25 -0.435259 0.123143 0.435261 1.99397 -0.123144 -1.99397 0.0 +773 2.75 3.65 33.75 -0.0493642 0.0652704 0.0493648 0.328683 -0.0652688 -0.328684 0.0 +774 2.75 3.65 41.25 -0.0146925 0.0282769 0.0146967 0.0813637 -0.0282736 -0.0813666 0.0 +775 2.75 3.65 48.75 -0.0246544 0.00490522 0.0246565 0.0166878 -0.00490432 -0.0166888 0.0 +776 2.75 3.65 56.25 -0.0139125 0.00395284 0.0139089 -0.00867723 -0.00395188 0.00867599 0.0 +777 2.75 3.65 63.75 -0.00270241 0.00619066 0.00270068 -0.00571762 -0.00619525 0.00571944 0.0 +778 2.75 3.65 71.25 0.000519918 0.00471435 -0.000521654 -8.15984e-06 -0.00471422 7.2579e-06 0.0 +779 2.75 3.65 78.75 0.000501459 0.00398609 -0.00050026 0.000797399 -0.00398918 -0.000797502 0.0 +780 2.75 3.65 86.25 -4.4671e-05 0.00352149 4.27284e-05 0.000514162 -0.00352011 -0.000514185 0.0 +781 2.75 3.65 93.75 -0.000889969 0.00110883 0.000890202 0.00115235 -0.00110879 -0.00115223 0.0 +782 2.75 3.65 101.25 -0.00151239 -0.00165277 0.00151236 0.00181475 0.00164834 -0.00181365 0.0 +783 2.75 3.65 108.75 -0.00161992 -0.00273717 0.00161755 0.00169929 0.00273792 -0.00169984 0.0 +784 2.75 3.65 116.25 -0.00158692 -0.00271981 0.00158207 0.00119301 0.00272293 -0.00119423 0.0 +785 2.75 3.65 123.75 -0.00161004 -0.0028994 0.00160522 0.000901196 0.00289974 -0.000900406 0.0 +786 2.75 3.65 131.25 -0.00135618 -0.00318701 0.00134929 0.000817217 0.00318514 -0.000815958 0.0 +787 2.75 3.65 138.75 -0.000562397 -0.00258908 0.000562926 0.000632375 0.00259618 -0.000635132 0.0 +788 2.75 3.65 146.25 0.000398525 -0.000673377 -0.000405592 0.000326015 0.000673344 -0.000326095 0.0 +789 2.75 3.65 153.75 0.000850024 0.00202598 -0.000855047 0.000185369 -0.00202081 -0.000188642 0.0 +790 2.75 3.65 161.25 0.000434663 0.00458686 -0.000435573 0.000417059 -0.00458533 -0.000417937 0.0 +791 2.75 3.65 168.75 -0.000552814 0.00638533 0.000542524 0.000898487 -0.00637922 -0.0009015 0.0 +792 2.75 3.65 176.25 -0.00133582 0.00725755 0.00133015 0.00128127 -0.0072543 -0.00128197 0.0 +793 2.85 2.85 3.75 -1116.76 -835.91 1116.76 26640.2 835.91 -26640.2 0.0 +794 2.85 2.85 11.25 -610.386 -506.696 610.386 5875.84 506.696 -5875.84 0.0 +795 2.85 2.85 18.75 -255.208 -239.613 255.208 1744.42 239.613 -1744.42 0.0 +796 2.85 2.85 26.25 -73.7604 -82.5484 73.7603 437.327 82.5484 -437.327 0.0 +797 2.85 2.85 33.75 -11.1104 -18.0796 11.1103 74.9581 18.0796 -74.9581 0.0 +798 2.85 2.85 41.25 0.228715 -1.87052 -0.228784 6.31518 1.87054 -6.31516 0.0 +799 2.85 2.85 48.75 -0.186912 -0.383005 0.186932 0.552533 0.382981 -0.552553 0.0 +800 2.85 2.85 56.25 -0.516548 -0.486964 0.51651 0.427331 0.486994 -0.427316 0.0 +801 2.85 2.85 63.75 -0.277336 -0.279457 0.277442 -0.0294235 0.279516 0.0294254 0.0 +802 2.85 2.85 71.25 -0.12864 -0.127184 0.128869 -0.180718 0.127225 0.180733 0.0 +803 2.85 2.85 78.75 -0.0484987 -0.0475193 0.0484573 -0.172173 0.0474804 0.172167 0.0 +804 2.85 2.85 86.25 0.047169 0.0422314 -0.0471278 -0.173173 -0.0422364 0.173175 0.0 +805 2.85 2.85 93.75 0.132895 0.126705 -0.132882 -0.167927 -0.126598 0.167928 0.0 +806 2.85 2.85 101.25 0.176042 0.170333 -0.17625 -0.134397 -0.170485 0.134408 0.0 +807 2.85 2.85 108.75 0.163576 0.157905 -0.16355 -0.0779511 -0.157842 0.0779731 0.0 +808 2.85 2.85 116.25 0.101997 0.0960507 -0.102078 -0.014347 -0.0959807 0.0143824 0.0 +809 2.85 2.85 123.75 0.0206725 0.0134256 -0.0205836 0.0381676 -0.0135693 -0.0381435 0.0 +810 2.85 2.85 131.25 -0.0539648 -0.0618543 0.0539695 0.071669 0.061813 -0.0716401 0.0 +811 2.85 2.85 138.75 -0.126558 -0.13291 0.126595 0.096029 0.132846 -0.0960093 0.0 +812 2.85 2.85 146.25 -0.226905 -0.229729 0.2268 0.129945 0.229804 -0.130004 0.0 +813 2.85 2.85 153.75 -0.375777 -0.37653 0.375708 0.184542 0.376441 -0.184502 0.0 +814 2.85 2.85 161.25 -0.55951 -0.56228 0.559638 0.254398 0.562318 -0.254441 0.0 +815 2.85 2.85 168.75 -0.731663 -0.739479 0.731781 0.320527 0.739524 -0.32053 0.0 +816 2.85 2.85 176.25 -0.836402 -0.848187 0.836322 0.360778 0.848245 -0.36086 0.0 +817 2.85 2.95 3.75 -1111.67 -671.504 1111.67 23382.6 671.504 -23382.6 0.0 +818 2.85 2.95 11.25 -624.121 -411.338 624.121 5761.08 411.338 -5761.08 0.0 +819 2.85 2.95 18.75 -267.855 -190.585 267.855 1715.29 190.585 -1715.29 0.0 +820 2.85 2.95 26.25 -82.9178 -61.5016 82.9177 426.265 61.5016 -426.265 0.0 +821 2.85 2.95 33.75 -16.5392 -10.9568 16.5393 72.4347 10.9568 -72.4348 0.0 +822 2.85 2.95 41.25 -2.05368 -0.128524 2.05363 6.25085 0.128465 -6.25081 0.0 +823 2.85 2.95 48.75 -0.636623 -0.11763 0.63655 0.514257 0.117589 -0.514248 0.0 +824 2.85 2.95 56.25 -0.408465 -0.491652 0.408393 0.327192 0.491696 -0.327194 0.0 +825 2.85 2.95 63.75 -0.201297 -0.331339 0.201309 -0.0209138 0.331453 0.0209243 0.0 +826 2.85 2.95 71.25 -0.130914 -0.18282 0.130989 -0.130552 0.182746 0.130536 0.0 +827 2.85 2.95 78.75 -0.0608924 -0.0898709 0.0607915 -0.139463 0.0899889 0.139453 0.0 +828 2.85 2.95 86.25 0.0345738 0.00746434 -0.0344701 -0.148244 -0.00754141 0.148234 0.0 +829 2.85 2.95 93.75 0.111119 0.0976325 -0.1113 -0.142909 -0.0978809 0.142911 0.0 +830 2.85 2.95 101.25 0.151941 0.155503 -0.151976 -0.117111 -0.15543 0.11711 0.0 +831 2.85 2.95 108.75 0.145751 0.160353 -0.145553 -0.0726376 -0.160204 0.0725882 0.0 +832 2.85 2.95 116.25 0.0915158 0.110131 -0.0916919 -0.0182529 -0.110235 0.0182768 0.0 +833 2.85 2.95 123.75 0.0152377 0.0331448 -0.0151991 0.0284008 -0.0330236 -0.0284138 0.0 +834 2.85 2.95 131.25 -0.0546463 -0.0389944 0.0545777 0.0573967 0.038874 -0.0573186 0.0 +835 2.85 2.95 138.75 -0.1187 -0.104823 0.118718 0.0772008 0.104764 -0.077174 0.0 +836 2.85 2.95 146.25 -0.204059 -0.191464 0.203984 0.105389 0.191495 -0.105464 0.0 +837 2.85 2.95 153.75 -0.330797 -0.320794 0.330923 0.152322 0.320747 -0.152296 0.0 +838 2.85 2.95 161.25 -0.488129 -0.483077 0.488236 0.213067 0.483198 -0.213056 0.0 +839 2.85 2.95 168.75 -0.635592 -0.636761 0.635765 0.270692 0.636908 -0.270728 0.0 +840 2.85 2.95 176.25 -0.725217 -0.730636 0.725177 0.305753 0.730739 -0.305825 0.0 +841 2.85 3.05 3.75 -991.274 -468.465 991.274 17235.6 468.465 -17235.6 0.0 +842 2.85 3.05 11.25 -573.802 -298.761 573.802 5231.29 298.761 -5231.29 0.0 +843 2.85 3.05 18.75 -246.923 -139.586 246.923 1584.79 139.586 -1584.79 0.0 +844 2.85 3.05 26.25 -76.3431 -44.1795 76.3432 390.143 44.1795 -390.143 0.0 +845 2.85 3.05 33.75 -15.4296 -7.24375 15.4295 64.979 7.24375 -64.979 0.0 +846 2.85 3.05 41.25 -1.99485 0.0867799 1.99484 5.41934 -0.0867462 -5.41932 0.0 +847 2.85 3.05 48.75 -0.466876 -0.194309 0.466823 0.319783 0.194325 -0.319796 0.0 +848 2.85 3.05 56.25 -0.247864 -0.498556 0.247809 0.194278 0.49852 -0.194293 0.0 +849 2.85 3.05 63.75 -0.160838 -0.374237 0.160788 -0.00452736 0.374195 0.00453271 0.0 +850 2.85 3.05 71.25 -0.138726 -0.24602 0.138704 -0.0733155 0.246086 0.0732922 0.0 +851 2.85 3.05 78.75 -0.0645345 -0.137898 0.0646711 -0.10598 0.137892 0.105997 0.0 +852 2.85 3.05 86.25 0.0266641 -0.0289336 -0.0265391 -0.125218 0.0289426 0.125216 0.0 +853 2.85 3.05 93.75 0.0897391 0.0651921 -0.0895906 -0.118986 -0.0650775 0.118989 0.0 +854 2.85 3.05 101.25 0.124171 0.131613 -0.123901 -0.0965881 -0.131532 0.0965755 0.0 +855 2.85 3.05 108.75 0.12195 0.150621 -0.122014 -0.0600585 -0.150659 0.0600667 0.0 +856 2.85 3.05 116.25 0.0781014 0.115484 -0.0778585 -0.0147582 -0.115247 0.0147179 0.0 +857 2.85 3.05 123.75 0.0150628 0.0506384 -0.0150425 0.0236392 -0.0506457 -0.023627 0.0 +858 2.85 3.05 131.25 -0.0400525 -0.0131487 0.0399632 0.0466779 0.0130289 -0.0466525 0.0 +859 2.85 3.05 138.75 -0.0895184 -0.0739947 0.0894657 0.0627374 0.0740386 -0.0627861 0.0 +860 2.85 3.05 146.25 -0.15904 -0.155412 0.159469 0.0871229 0.155461 -0.0870861 0.0 +861 2.85 3.05 153.75 -0.267082 -0.274606 0.267172 0.127796 0.274496 -0.127765 0.0 +862 2.85 3.05 161.25 -0.401901 -0.419629 0.401826 0.179668 0.41968 -0.179776 0.0 +863 2.85 3.05 168.75 -0.527756 -0.553697 0.527878 0.228247 0.553582 -0.228199 0.0 +864 2.85 3.05 176.25 -0.604226 -0.634443 0.604143 0.25757 0.634535 -0.257606 0.0 +865 2.85 3.15 3.75 -806.102 -265.526 806.102 12165.1 265.526 -12165.1 0.0 +866 2.85 3.15 11.25 -477.611 -181.207 477.611 4442.53 181.207 -4442.53 0.0 +867 2.85 3.15 18.75 -202.862 -88.6434 202.862 1380.02 88.6434 -1380.02 0.0 +868 2.85 3.15 26.25 -60.0987 -29.0515 60.0987 336.188 29.0515 -336.188 0.0 +869 2.85 3.15 33.75 -10.968 -5.19052 10.9681 54.504 5.19046 -54.5041 0.0 +870 2.85 3.15 41.25 -1.05094 -0.312006 1.05086 4.33851 0.311981 -4.33846 0.0 +871 2.85 3.15 48.75 -0.213743 -0.352928 0.213728 0.164252 0.352886 -0.164263 0.0 +872 2.85 3.15 56.25 -0.154279 -0.471869 0.154225 0.093218 0.47198 -0.0932153 0.0 +873 2.85 3.15 63.75 -0.141604 -0.388768 0.141653 0.0126807 0.388761 -0.0126585 0.0 +874 2.85 3.15 71.25 -0.130127 -0.294635 0.130139 -0.0263984 0.294556 0.0263117 0.0 +875 2.85 3.15 78.75 -0.0550277 -0.180465 0.0550203 -0.073421 0.180561 0.0734297 0.0 +876 2.85 3.15 86.25 0.0209399 -0.0643701 -0.0207919 -0.0962653 0.0644703 0.0962704 0.0 +877 2.85 3.15 93.75 0.0659847 0.032253 -0.0661012 -0.0898107 -0.0322317 0.0898055 0.0 +878 2.85 3.15 101.25 0.0929454 0.104785 -0.092671 -0.0721152 -0.104858 0.0721226 0.0 +879 2.85 3.15 108.75 0.0923534 0.135562 -0.0925163 -0.0438144 -0.135405 0.0437756 0.0 +880 2.85 3.15 116.25 0.0576885 0.115491 -0.0573926 -0.00846383 -0.115386 0.00845008 0.0 +881 2.85 3.15 123.75 0.00835101 0.0659492 -0.00830537 0.0204391 -0.0659776 -0.020473 0.0 +882 2.85 3.15 131.25 -0.0330033 0.0137364 0.0330472 0.0368218 -0.0138501 -0.0368043 0.0 +883 2.85 3.15 138.75 -0.0696344 -0.0403338 0.0693805 0.0485567 0.0403552 -0.0486203 0.0 +884 2.85 3.15 146.25 -0.123646 -0.114761 0.123498 0.0676978 0.114704 -0.0677341 0.0 +885 2.85 3.15 153.75 -0.209228 -0.220305 0.209164 0.0995682 0.220152 -0.0994412 0.0 +886 2.85 3.15 161.25 -0.316292 -0.3444 0.316446 0.139549 0.344477 -0.139654 0.0 +887 2.85 3.15 168.75 -0.416182 -0.455814 0.416144 0.176494 0.455746 -0.176411 0.0 +888 2.85 3.15 176.25 -0.476042 -0.521785 0.476 0.198621 0.521756 -0.198557 0.0 +889 2.85 3.25 3.75 -599.006 -91.2154 599.006 8491.46 91.2155 -8491.46 0.0 +890 2.85 3.25 11.25 -359.488 -74.6727 359.488 3559.49 74.6727 -3559.49 0.0 +891 2.85 3.25 18.75 -148.661 -42.6777 148.661 1135.12 42.6777 -1135.12 0.0 +892 2.85 3.25 26.25 -40.7166 -16.0322 40.7166 272.812 16.0322 -272.812 0.0 +893 2.85 3.25 33.75 -5.97051 -3.67296 5.97039 42.68 3.67297 -42.68 0.0 +894 2.85 3.25 41.25 -0.182688 -0.670468 0.182753 3.20438 0.670474 -3.20441 0.0 +895 2.85 3.25 48.75 -0.0747798 -0.425329 0.0748223 0.0657742 0.425365 -0.0658515 0.0 +896 2.85 3.25 56.25 -0.0982934 -0.398958 0.0982134 0.0220039 0.399004 -0.0220176 0.0 +897 2.85 3.25 63.75 -0.100813 -0.360976 0.100898 0.0133885 0.360825 -0.0133447 0.0 +898 2.85 3.25 71.25 -0.0945309 -0.307881 0.0945963 -0.00420512 0.307879 0.00421061 0.0 +899 2.85 3.25 78.75 -0.0366795 -0.207353 0.0366632 -0.0482296 0.20741 0.0482248 0.0 +900 2.85 3.25 86.25 0.0149887 -0.0970942 -0.0150626 -0.0654125 0.0972336 0.0654212 0.0 +901 2.85 3.25 93.75 0.0443972 -0.00226785 -0.0443982 -0.0599009 0.00218497 0.0598939 0.0 +902 2.85 3.25 101.25 0.0653842 0.0743707 -0.0655475 -0.0488889 -0.074459 0.048906 0.0 +903 2.85 3.25 108.75 0.0673028 0.115282 -0.0672563 -0.0293956 -0.115121 0.0293551 0.0 +904 2.85 3.25 116.25 0.041101 0.109791 -0.041206 -0.00426137 -0.110092 0.0043584 0.0 +905 2.85 3.25 123.75 0.0030353 0.0756594 -0.00306469 0.0153374 -0.0756692 -0.0152926 0.0 +906 2.85 3.25 131.25 -0.02782 0.0350328 0.0279329 0.0256415 -0.0350474 -0.0256136 0.0 +907 2.85 3.25 138.75 -0.0538742 -0.00966993 0.0537414 0.0330967 0.00970634 -0.033162 0.0 +908 2.85 3.25 146.25 -0.0905357 -0.070843 0.0905608 0.0460454 0.0707919 -0.045972 0.0 +909 2.85 3.25 153.75 -0.14887 -0.15562 0.148901 0.0676893 0.155618 -0.067644 0.0 +910 2.85 3.25 161.25 -0.22216 -0.252709 0.22219 0.0946651 0.252847 -0.0946834 0.0 +911 2.85 3.25 168.75 -0.290593 -0.338691 0.290381 0.119487 0.33884 -0.119576 0.0 +912 2.85 3.25 176.25 -0.3308 -0.388801 0.331427 0.13433 0.388853 -0.134296 0.0 +913 2.85 3.35 3.75 -386.528 33.5021 386.528 5634.36 -33.5021 -5634.36 0.0 +914 2.85 3.35 11.25 -232.313 5.67109 232.313 2604.32 -5.67109 -2604.32 0.0 +915 2.85 3.35 18.75 -91.9697 -7.27714 91.9697 849.253 7.27716 -849.253 0.0 +916 2.85 3.35 26.25 -22.1609 -5.78613 22.161 200.148 5.78612 -200.148 0.0 +917 2.85 3.35 33.75 -1.98022 -2.12648 1.98024 29.7672 2.12648 -29.7672 0.0 +918 2.85 3.35 41.25 0.243179 -0.637377 -0.243178 2.04091 0.637344 -2.04094 0.0 +919 2.85 3.35 48.75 -0.0543799 -0.361761 0.0543227 0.0128587 0.36182 -0.0128186 0.0 +920 2.85 3.35 56.25 -0.053243 -0.315179 0.0533037 -0.0175621 0.315135 0.0175499 0.0 +921 2.85 3.35 63.75 -0.0463022 -0.314223 0.0463235 0.00311652 0.314212 -0.00320789 0.0 +922 2.85 3.35 71.25 -0.0532898 -0.296211 0.0534137 -0.000155585 0.29602 0.000135295 0.0 +923 2.85 3.35 78.75 -0.0212587 -0.22246 0.0212696 -0.0288431 0.222559 0.0288631 0.0 +924 2.85 3.35 86.25 0.00889954 -0.125343 -0.00894718 -0.0369629 0.125394 0.0369644 0.0 +925 2.85 3.35 93.75 0.0262325 -0.0313862 -0.0263584 -0.0340369 0.0311982 0.0340506 0.0 +926 2.85 3.35 101.25 0.0415953 0.0498466 -0.0414478 -0.0293926 -0.0498895 0.0293844 0.0 +927 2.85 3.35 108.75 0.0450451 0.0995096 -0.0449831 -0.0178232 -0.0997351 0.0178778 0.0 +928 2.85 3.35 116.25 0.028077 0.105738 -0.0281433 -0.00230595 -0.105795 0.00235292 0.0 +929 2.85 3.35 123.75 0.00116088 0.0815732 -0.000852722 0.00942911 -0.0816637 -0.00933158 0.0 +930 2.85 3.35 131.25 -0.0216069 0.0479562 0.0217652 0.0156247 -0.0476846 -0.0157325 0.0 +931 2.85 3.35 138.75 -0.0380909 0.0111308 0.0380157 0.0201099 -0.0113054 -0.0200733 0.0 +932 2.85 3.35 146.25 -0.0570642 -0.0359703 0.0570676 0.0273788 0.0359094 -0.0273053 0.0 +933 2.85 3.35 153.75 -0.0874487 -0.0993169 0.0874531 0.0394423 0.0994037 -0.0393806 0.0 +934 2.85 3.35 161.25 -0.127843 -0.172492 0.127557 0.054893 0.172359 -0.0549082 0.0 +935 2.85 3.35 168.75 -0.166559 -0.237682 0.166614 0.0695468 0.237554 -0.0695277 0.0 +936 2.85 3.35 176.25 -0.191 -0.276276 0.19078 0.0784958 0.276377 -0.0785403 0.0 +937 2.85 3.45 3.75 -161.588 70.6187 161.588 2741.33 -70.6187 -2741.33 0.0 +938 2.85 3.45 11.25 -95.5114 34.9158 95.5114 1355.81 -34.9158 -1355.81 0.0 +939 2.85 3.45 18.75 -34.6683 8.27267 34.6684 448.865 -8.27268 -448.865 0.0 +940 2.85 3.45 26.25 -6.16493 -0.139582 6.16494 102.857 0.139618 -102.857 0.0 +941 2.85 3.45 33.75 0.422229 -0.589501 -0.422207 14.2949 0.589425 -14.2948 0.0 +942 2.85 3.45 41.25 0.271293 -0.179716 -0.271334 0.90093 0.179724 -0.900935 0.0 +943 2.85 3.45 48.75 -0.0728654 -0.170806 0.0729137 0.0252674 0.1707 -0.025252 0.0 +944 2.85 3.45 56.25 -0.0333377 -0.213039 0.0332742 -0.0156257 0.212999 0.0155434 0.0 +945 2.85 3.45 63.75 -0.0152903 -0.227014 0.0151849 -0.00379666 0.227029 0.00381385 0.0 +946 2.85 3.45 71.25 -0.0235692 -0.224061 0.0235144 -0.000903934 0.22407 0.000862594 0.0 +947 2.85 3.45 78.75 -0.00941949 -0.180683 0.00940751 -0.0122182 0.180688 0.0122354 0.0 +948 2.85 3.45 86.25 0.00386563 -0.108855 -0.00384482 -0.0147672 0.108894 0.0147696 0.0 +949 2.85 3.45 93.75 0.00738598 -0.0352297 -0.00746621 -0.0134146 0.0352537 0.0134097 0.0 +950 2.85 3.45 101.25 0.0113163 0.0272447 -0.0112177 -0.0108832 -0.027162 0.0109037 0.0 +951 2.85 3.45 108.75 0.0143535 0.0674421 -0.0144727 -0.00585159 -0.0674317 0.00583747 0.0 +952 2.85 3.45 116.25 0.0102386 0.0775271 -0.0102071 -0.000339014 -0.0776401 0.000348303 0.0 +953 2.85 3.45 123.75 2.58732e-05 0.0640245 -4.10589e-05 0.00384167 -0.0641439 -0.00376402 0.0 +954 2.85 3.45 131.25 -0.00902431 0.0415235 0.00900971 0.00644527 -0.0416055 -0.00641701 0.0 +955 2.85 3.45 138.75 -0.0130822 0.0181696 0.0131824 0.00773263 -0.0182103 -0.00771311 0.0 +956 2.85 3.45 146.25 -0.0161839 -0.00998922 0.016076 0.00888536 0.00978667 -0.00879601 0.0 +957 2.85 3.45 153.75 -0.0242202 -0.0483692 0.0241807 0.011811 0.0483358 -0.0118472 0.0 +958 2.85 3.45 161.25 -0.0396328 -0.0952296 0.0395522 0.0172745 0.0951821 -0.0172176 0.0 +959 2.85 3.45 168.75 -0.0578248 -0.139644 0.0577311 0.0236934 0.13953 -0.0236387 0.0 +960 2.85 3.45 176.25 -0.0700834 -0.166806 0.0701114 0.0280544 0.166621 -0.0279388 0.0 +961 2.85 3.55 3.75 -31.029 33.8429 31.029 807.354 -33.8429 -807.354 0.0 +962 2.85 3.55 11.25 -16.6941 17.1581 16.6942 418.065 -17.1581 -418.065 0.0 +963 2.85 3.55 18.75 -3.99472 4.08748 3.9947 139.471 -4.08747 -139.471 0.0 +964 2.85 3.55 26.25 0.82754 0.00960473 -0.827538 30.9637 -0.00959943 -30.9637 0.0 +965 2.85 3.55 33.75 0.904557 -0.081934 -0.904543 4.11608 0.0819614 -4.11609 0.0 +966 2.85 3.55 41.25 0.170681 0.0848305 -0.170682 0.346509 -0.0848039 -0.34653 0.0 +967 2.85 3.55 48.75 -0.0666717 -0.0106917 0.0666836 0.0541797 0.0106909 -0.0541811 0.0 +968 2.85 3.55 56.25 -0.0367163 -0.0711844 0.0367427 -0.00758183 0.0712025 0.00758489 0.0 +969 2.85 3.55 63.75 -0.00980718 -0.0797592 0.00983424 -0.00697712 0.0797424 0.00697812 0.0 +970 2.85 3.55 71.25 -0.00586824 -0.0828521 0.00590764 -3.50261e-07 0.0828154 -9.47724e-06 0.0 +971 2.85 3.55 78.75 -0.000602709 -0.0682983 0.000612821 -0.00212227 0.0683145 0.00213184 0.0 +972 2.85 3.55 86.25 0.000973121 -0.0398569 -0.000961009 -0.00335451 0.0398316 0.00334909 0.0 +973 2.85 3.55 93.75 -0.00358082 -0.0150889 0.00357048 -0.00152868 0.0150508 0.00152981 0.0 +974 2.85 3.55 101.25 -0.00603736 0.00394172 0.00605293 0.000730934 -0.00393071 -0.000744155 0.0 +975 2.85 3.55 108.75 -0.00335262 0.0195109 0.00322804 0.00102238 -0.0194668 -0.00104163 0.0 +976 2.85 3.55 116.25 0.000444349 0.027755 -0.000387332 8.69624e-05 -0.0277462 -9.75392e-05 0.0 +977 2.85 3.55 123.75 0.0014088 0.0269113 -0.00138674 -7.73086e-05 -0.0268849 6.29337e-05 0.0 +978 2.85 3.55 131.25 0.00165964 0.0217477 -0.00165364 0.000223061 -0.0218041 -0.000187964 0.0 +979 2.85 3.55 138.75 0.00401875 0.0169663 -0.00395318 -0.000703326 -0.016976 0.000717988 0.0 +980 2.85 3.55 146.25 0.00768509 0.0118145 -0.00765824 -0.00287592 -0.0118411 0.00289573 0.0 +981 2.85 3.55 153.75 0.00912573 0.00261415 -0.00905729 -0.00443259 -0.00257542 0.00443667 0.0 +982 2.85 3.55 161.25 0.0057808 -0.0119115 -0.00584887 -0.00390544 0.0118818 0.00391874 0.0 +983 2.85 3.55 168.75 -0.000422092 -0.0276521 0.000431626 -0.00177835 0.0276894 0.00174946 0.0 +984 2.85 3.55 176.25 -0.00538109 -0.0379719 0.00540295 7.43942e-05 0.0379802 -5.26705e-05 0.0 +985 2.85 3.65 3.75 0.117993 2.41395 -0.117994 63.6242 -2.41395 -63.6242 0.0 +986 2.85 3.65 11.25 0.547196 0.863222 -0.547196 34.0061 -0.86322 -34.0061 0.0 +987 2.85 3.65 18.75 0.745937 -0.193692 -0.745936 11.4296 0.193693 -11.4296 0.0 +988 2.85 3.65 26.25 0.543519 -0.28335 -0.54352 2.53726 0.28335 -2.53726 0.0 +989 2.85 3.65 33.75 0.224853 -0.0795795 -0.224852 0.395802 0.0795803 -0.395805 0.0 +990 2.85 3.65 41.25 0.0308566 0.0096513 -0.030854 0.0760108 -0.00965396 -0.0760089 0.0 +991 2.85 3.65 48.75 -0.0200071 0.0114374 0.0200007 0.0152694 -0.0114346 -0.0152666 0.0 +992 2.85 3.65 56.25 -0.0121781 0.00806958 0.0121778 -0.00463886 -0.00806824 0.00463935 0.0 +993 2.85 3.65 63.75 -0.00240079 0.00691829 0.00239728 -0.00287853 -0.00691891 0.00287832 0.0 +994 2.85 3.65 71.25 -0.000113974 0.00344927 0.000114402 0.000925612 -0.00345159 -0.000924517 0.0 +995 2.85 3.65 78.75 -0.000150972 0.00204618 0.000149514 0.00127176 -0.00204528 -0.00127259 0.0 +996 2.85 3.65 86.25 -0.00063721 0.00167632 0.000641885 0.000872705 -0.00167479 -0.000872293 0.0 +997 2.85 3.65 93.75 -0.00144962 -0.000316034 0.00144811 0.00113858 0.000313733 -0.00113842 0.0 +998 2.85 3.65 101.25 -0.00167523 -0.00216785 0.00167369 0.00123363 0.00216868 -0.00123425 0.0 +999 2.85 3.65 108.75 -0.00110878 -0.00207464 0.00110977 0.00064396 0.00207751 -0.000643732 0.0 +1000 2.85 3.65 116.25 -0.000764004 -0.00128655 0.000766131 0.000103318 0.00128453 -0.000103182 0.0 +1001 2.85 3.65 123.75 -0.00123412 -0.00134957 0.00123183 0.000216939 0.00135724 -0.000220275 0.0 +1002 2.85 3.65 131.25 -0.00184917 -0.00183778 0.00184664 0.000577507 0.00184059 -0.000579396 0.0 +1003 2.85 3.65 138.75 -0.00163391 -0.00138008 0.00162307 0.000515544 0.00137553 -0.000512344 0.0 +1004 2.85 3.65 146.25 -0.000376327 0.000499681 0.00037387 -6.6379e-06 -0.000506003 1.01884e-05 0.0 +1005 2.85 3.65 153.75 0.00121458 0.00310539 -0.00122162 -0.000485719 -0.00311088 0.000488173 0.0 +1006 2.85 3.65 161.25 0.00238865 0.00543453 -0.0023833 -0.00051915 -0.00542809 0.000516147 0.0 +1007 2.85 3.65 168.75 0.00285962 0.00692717 -0.00285792 -0.000171476 -0.00692344 0.000168255 0.0 +1008 2.85 3.65 176.25 0.00292307 0.00758779 -0.00292581 0.00016883 -0.00759567 -0.000164093 0.0 +1009 2.95 2.95 3.75 -1235.79 -703.549 1235.79 26126.6 703.549 -26126.6 0.0 +1010 2.95 2.95 11.25 -677.675 -435.614 677.675 5671.31 435.614 -5671.31 0.0 +1011 2.95 2.95 18.75 -281.882 -206.464 281.882 1620.38 206.464 -1620.38 0.0 +1012 2.95 2.95 26.25 -80.142 -69.4145 80.142 377.367 69.4145 -377.367 0.0 +1013 2.95 2.95 33.75 -11.535 -14.0454 11.535 55.1741 14.0454 -55.1741 0.0 +1014 2.95 2.95 41.25 0.444691 -1.06867 -0.444678 2.44606 1.06872 -2.44609 0.0 +1015 2.95 2.95 48.75 -0.095339 -0.280002 0.095379 0.150135 0.280037 -0.150155 0.0 +1016 2.95 2.95 56.25 -0.487332 -0.457247 0.487298 0.373103 0.457341 -0.373058 0.0 +1017 2.95 2.95 63.75 -0.309733 -0.308057 0.309669 0.0352679 0.308082 -0.0352801 0.0 +1018 2.95 2.95 71.25 -0.189494 -0.187337 0.189429 -0.0767338 0.187338 0.0767722 0.0 +1019 2.95 2.95 78.75 -0.100558 -0.0943326 0.100538 -0.103742 0.0942838 0.103711 0.0 +1020 2.95 2.95 86.25 -0.00127159 0.00259697 0.00111691 -0.124177 -0.0027075 0.124174 0.0 +1021 2.95 2.95 93.75 0.0781938 0.0795056 -0.0783669 -0.119644 -0.0795165 0.119632 0.0 +1022 2.95 2.95 101.25 0.125437 0.125749 -0.125346 -0.0954926 -0.125695 0.0954816 0.0 +1023 2.95 2.95 108.75 0.131842 0.132451 -0.1318 -0.0582993 -0.132316 0.0582686 0.0 +1024 2.95 2.95 116.25 0.094036 0.0945768 -0.0939986 -0.013007 -0.0944018 0.0129685 0.0 +1025 2.95 2.95 123.75 0.031853 0.0309302 -0.0318676 0.0276584 -0.0309157 -0.0276663 0.0 +1026 2.95 2.95 131.25 -0.0289236 -0.0307662 0.0290267 0.0542911 0.0309129 -0.0543246 0.0 +1027 2.95 2.95 138.75 -0.0860191 -0.0873603 0.0858184 0.0715543 0.0871918 -0.0715138 0.0 +1028 2.95 2.95 146.25 -0.159015 -0.159395 0.158823 0.092785 0.159333 -0.0927604 0.0 +1029 2.95 2.95 153.75 -0.264066 -0.265928 0.264092 0.127317 0.266003 -0.127385 0.0 +1030 2.95 2.95 161.25 -0.392832 -0.399313 0.392736 0.172881 0.399453 -0.172904 0.0 +1031 2.95 2.95 168.75 -0.51305 -0.525949 0.512818 0.216982 0.526087 -0.217102 0.0 +1032 2.95 2.95 176.25 -0.585362 -0.603164 0.585535 0.244165 0.603114 -0.244128 0.0 +1033 2.95 3.05 3.75 -1152 -470.691 1152 22546.9 470.691 -22546.9 0.0 +1034 2.95 3.05 11.25 -646.366 -302.989 646.366 5436.44 302.989 -5436.44 0.0 +1035 2.95 3.05 18.75 -274.735 -144.566 274.735 1560.79 144.566 -1560.79 0.0 +1036 2.95 3.05 26.25 -82.9595 -46.7837 82.9596 363.128 46.7837 -363.128 0.0 +1037 2.95 3.05 33.75 -15.5348 -7.90904 15.5348 54.2888 7.90907 -54.2887 0.0 +1038 2.95 3.05 41.25 -1.52533 0.0877815 1.52529 3.23039 -0.0877658 -3.23043 0.0 +1039 2.95 3.05 48.75 -0.429791 -0.130249 0.429777 0.249314 0.130206 -0.249273 0.0 +1040 2.95 3.05 56.25 -0.354386 -0.465805 0.3544 0.285906 0.465883 -0.285905 0.0 +1041 2.95 3.05 63.75 -0.230807 -0.353693 0.230714 0.0451008 0.353768 -0.0451234 0.0 +1042 2.95 3.05 71.25 -0.171943 -0.228248 0.172051 -0.0442061 0.228171 0.0442394 0.0 +1043 2.95 3.05 78.75 -0.0886759 -0.125763 0.0886157 -0.0870429 0.125748 0.0870611 0.0 +1044 2.95 3.05 86.25 0.00406016 -0.0290639 -0.00400943 -0.106637 0.0291333 0.106635 0.0 +1045 2.95 3.05 93.75 0.0709324 0.0512843 -0.0709031 -0.0997352 -0.0513256 0.0997471 0.0 +1046 2.95 3.05 101.25 0.112173 0.109307 -0.112111 -0.081026 -0.10938 0.0810188 0.0 +1047 2.95 3.05 108.75 0.118241 0.127448 -0.118156 -0.0508854 -0.127498 0.0509172 0.0 +1048 2.95 3.05 116.25 0.082375 0.0967194 -0.0826216 -0.0115758 -0.096743 0.0116038 0.0 +1049 2.95 3.05 123.75 0.0249719 0.0392243 -0.0250633 0.0233571 -0.0393156 -0.0232965 0.0 +1050 2.95 3.05 131.25 -0.0283614 -0.0168684 0.0282743 0.0451621 0.0168661 -0.045173 0.0 +1051 2.95 3.05 138.75 -0.0768736 -0.0688048 0.077069 0.0594051 0.068716 -0.0593073 0.0 +1052 2.95 3.05 146.25 -0.141563 -0.136731 0.141568 0.0784955 0.136426 -0.0784076 0.0 +1053 2.95 3.05 153.75 -0.236122 -0.235072 0.236058 0.109983 0.235346 -0.110141 0.0 +1054 2.95 3.05 161.25 -0.351579 -0.354851 0.351474 0.150951 0.354689 -0.150832 0.0 +1055 2.95 3.05 168.75 -0.458428 -0.465918 0.458345 0.190063 0.465592 -0.18999 0.0 +1056 2.95 3.05 176.25 -0.522577 -0.532559 0.52258 0.213967 0.532625 -0.214084 0.0 +1057 2.95 3.15 3.75 -947.105 -234.064 947.105 16388.2 234.064 -16388.2 0.0 +1058 2.95 3.15 11.25 -544.957 -169.572 544.957 4831.85 169.572 -4831.85 0.0 +1059 2.95 3.15 18.75 -231.218 -87.4264 231.218 1411.96 87.4264 -1411.96 0.0 +1060 2.95 3.15 26.25 -69.489 -29.5946 69.489 327.211 29.5945 -327.211 0.0 +1061 2.95 3.15 33.75 -13.2484 -5.06717 13.2484 48.9414 5.06717 -48.9414 0.0 +1062 2.95 3.15 41.25 -1.4679 0.0238403 1.46795 3.15011 -0.0239097 -3.15014 0.0 +1063 2.95 3.15 48.75 -0.31652 -0.227201 0.316586 0.172569 0.227204 -0.17262 0.0 +1064 2.95 3.15 56.25 -0.21369 -0.480095 0.213689 0.184024 0.480141 -0.184087 0.0 +1065 2.95 3.15 63.75 -0.176969 -0.390853 0.176921 0.0560194 0.390826 -0.0559763 0.0 +1066 2.95 3.15 71.25 -0.150417 -0.269717 0.150456 -0.0151382 0.269771 0.0150882 0.0 +1067 2.95 3.15 78.75 -0.0732588 -0.158111 0.073298 -0.0675252 0.157991 0.0675219 0.0 +1068 2.95 3.15 86.25 0.0011828 -0.0578942 -0.0013546 -0.0836453 0.0579193 0.083656 0.0 +1069 2.95 3.15 93.75 0.0495663 0.0262723 -0.0495336 -0.0758505 -0.0265178 0.0758585 0.0 +1070 2.95 3.15 101.25 0.0825033 0.0923783 -0.0825646 -0.0624571 -0.0924447 0.0624949 0.0 +1071 2.95 3.15 108.75 0.0903024 0.12085 -0.0901393 -0.0395117 -0.120852 0.0395202 0.0 +1072 2.95 3.15 116.25 0.0638444 0.102339 -0.0638579 -0.00894728 -0.102235 0.00890468 0.0 +1073 2.95 3.15 123.75 0.0220461 0.0572511 -0.0219022 0.0169359 -0.0570113 -0.0169543 0.0 +1074 2.95 3.15 131.25 -0.015441 0.00943891 0.0156538 0.0325133 -0.00947592 -0.0324612 0.0 +1075 2.95 3.15 138.75 -0.0518112 -0.0403117 0.0516345 0.043965 0.0403656 -0.0440096 0.0 +1076 2.95 3.15 146.25 -0.104883 -0.106935 0.104923 0.0610883 0.106832 -0.0610049 0.0 +1077 2.95 3.15 153.75 -0.185793 -0.19961 0.185681 0.0885896 0.199403 -0.0885392 0.0 +1078 2.95 3.15 161.25 -0.283884 -0.306665 0.283899 0.123061 0.306488 -0.122974 0.0 +1079 2.95 3.15 168.75 -0.3736 -0.401945 0.373662 0.155182 0.401946 -0.155094 0.0 +1080 2.95 3.15 176.25 -0.427053 -0.458118 0.427085 0.174567 0.458223 -0.174634 0.0 +1081 2.95 3.25 3.75 -684.962 -33.597 684.962 11353.2 33.597 -11353.2 0.0 +1082 2.95 3.25 11.25 -400.069 -51.4433 400.069 4016.56 51.4433 -4016.56 0.0 +1083 2.95 3.25 18.75 -165.833 -38.5931 165.833 1203.1 38.5931 -1203.1 0.0 +1084 2.95 3.25 26.25 -47.263 -16.6148 47.263 276.987 16.6148 -276.987 0.0 +1085 2.95 3.25 33.75 -8.14408 -3.80756 8.14405 40.878 3.80754 -40.8779 0.0 +1086 2.95 3.25 41.25 -0.735673 -0.396549 0.73574 2.63773 0.396509 -2.63772 0.0 +1087 2.95 3.25 48.75 -0.150431 -0.333017 0.150544 0.0672603 0.332896 -0.0672187 0.0 +1088 2.95 3.25 56.25 -0.10876 -0.446971 0.10866 0.0972865 0.44696 -0.0973988 0.0 +1089 2.95 3.25 63.75 -0.118865 -0.37823 0.118992 0.0520019 0.378268 -0.052 0.0 +1090 2.95 3.25 71.25 -0.109895 -0.280626 0.109945 -0.000890606 0.280499 0.000905523 0.0 +1091 2.95 3.25 78.75 -0.0507365 -0.181073 0.0507334 -0.0461242 0.18097 0.0461348 0.0 +1092 2.95 3.25 86.25 -0.000734511 -0.0871476 0.00060714 -0.0555662 0.0872154 0.0555746 0.0 +1093 2.95 3.25 93.75 0.0311957 -0.00236195 -0.0311942 -0.0515041 0.00259597 0.0514843 0.0 +1094 2.95 3.25 101.25 0.0572093 0.0688848 -0.0571052 -0.0452318 -0.0687382 0.0452149 0.0 +1095 2.95 3.25 108.75 0.064287 0.106942 -0.0642778 -0.029198 -0.106939 0.0292002 0.0 +1096 2.95 3.25 116.25 0.0445212 0.10208 -0.0444717 -0.00721917 -0.102122 0.00721939 0.0 +1097 2.95 3.25 123.75 0.0135976 0.0703346 -0.0132914 0.0101515 -0.070214 -0.0102111 0.0 +1098 2.95 3.25 131.25 -0.0135575 0.0313234 0.0136726 0.0203596 -0.0316066 -0.0203055 0.0 +1099 2.95 3.25 138.75 -0.0393187 -0.0123616 0.0392606 0.0289017 0.0125322 -0.0289811 0.0 +1100 2.95 3.25 146.25 -0.0783219 -0.0713966 0.0781054 0.0422706 0.0716338 -0.0424701 0.0 +1101 2.95 3.25 153.75 -0.137718 -0.149787 0.137636 0.0630045 0.149918 -0.0630855 0.0 +1102 2.95 3.25 161.25 -0.209697 -0.23746 0.209832 0.0883427 0.237538 -0.0884379 0.0 +1103 2.95 3.25 168.75 -0.275371 -0.313873 0.275402 0.111664 0.314062 -0.111753 0.0 +1104 2.95 3.25 176.25 -0.314348 -0.358242 0.314391 0.125665 0.357993 -0.125515 0.0 +1105 2.95 3.35 3.75 -399.508 103.619 399.508 7451.41 -103.619 -7451.41 0.0 +1106 2.95 3.35 11.25 -231.405 35.127 231.405 3026.44 -35.127 -3026.44 0.0 +1107 2.95 3.35 18.75 -89.8146 -2.33149 89.8146 930.13 2.3315 -930.13 0.0 +1108 2.95 3.35 26.25 -22.0607 -7.1465 22.0607 211.828 7.14652 -211.828 0.0 +1109 2.95 3.35 33.75 -2.61211 -2.84669 2.61203 30.3988 2.84678 -30.3988 0.0 +1110 2.95 3.35 41.25 -0.0641668 -0.572722 0.0641482 1.85321 0.572769 -1.85319 0.0 +1111 2.95 3.35 48.75 -0.0727144 -0.324155 0.0726592 -0.0128306 0.324113 0.0128188 0.0 +1112 2.95 3.35 56.25 -0.0429539 -0.369477 0.0429431 0.0365148 0.369487 -0.0365382 0.0 +1113 2.95 3.35 63.75 -0.0600198 -0.322362 0.0600919 0.0327313 0.322318 -0.0327163 0.0 +1114 2.95 3.35 71.25 -0.0652833 -0.262303 0.0652719 -0.000945077 0.262315 0.000937457 0.0 +1115 2.95 3.35 78.75 -0.031022 -0.194374 0.0309769 -0.0267122 0.194554 0.0267582 0.0 +1116 2.95 3.35 86.25 -0.00184005 -0.113162 0.00176104 -0.0298197 0.113076 0.0298218 0.0 +1117 2.95 3.35 93.75 0.018586 -0.0277066 -0.0184827 -0.0312711 0.0276271 0.0312812 0.0 +1118 2.95 3.35 101.25 0.0371138 0.0478631 -0.037144 -0.0299553 -0.0480008 0.0299616 0.0 +1119 2.95 3.35 108.75 0.0423982 0.093388 -0.0422422 -0.0188882 -0.0933397 0.0188857 0.0 +1120 2.95 3.35 116.25 0.0273758 0.0979945 -0.0273687 -0.00448478 -0.0979721 0.00447213 0.0 +1121 2.95 3.35 123.75 0.00420771 0.0743592 -0.00427898 0.00600864 -0.0745728 -0.0058675 0.0 +1122 2.95 3.35 131.25 -0.0145851 0.0414175 0.0147362 0.0124371 -0.0414414 -0.0124358 0.0 +1123 2.95 3.35 138.75 -0.03007 0.00528296 0.0300369 0.0181261 -0.00525075 -0.018187 0.0 +1124 2.95 3.35 146.25 -0.0509356 -0.0404972 0.0512567 0.0264418 0.040464 -0.0264103 0.0 +1125 2.95 3.35 153.75 -0.0853645 -0.10106 0.0852954 0.0392425 0.100971 -0.0391701 0.0 +1126 2.95 3.35 161.25 -0.129326 -0.170331 0.12924 0.0554642 0.170326 -0.0554588 0.0 +1127 2.95 3.35 168.75 -0.171342 -0.232151 0.171081 0.0709676 0.232288 -0.0710617 0.0 +1128 2.95 3.35 176.25 -0.196671 -0.268622 0.196769 0.0804998 0.268617 -0.0804939 0.0 +1129 2.95 3.45 3.75 -118.47 124.094 118.47 3596.85 -124.094 -3596.85 0.0 +1130 2.95 3.45 11.25 -62.0251 58.1208 62.0251 1612.69 -58.1208 -1612.69 0.0 +1131 2.95 3.45 18.75 -17.2025 11.8124 17.2025 506.519 -11.8125 -506.519 0.0 +1132 2.95 3.45 26.25 -0.377844 -1.71658 0.37789 113.34 1.71654 -113.34 0.0 +1133 2.95 3.45 33.75 1.37632 -1.48954 -1.37633 15.5555 1.4896 -15.5555 0.0 +1134 2.95 3.45 41.25 0.265026 -0.272138 -0.265013 0.865629 0.272128 -0.865594 0.0 +1135 2.95 3.45 48.75 -0.0675124 -0.169675 0.0675642 -0.0146368 0.169647 0.0146363 0.0 +1136 2.95 3.45 56.25 -0.023388 -0.236641 0.0234179 0.015066 0.236607 -0.015018 0.0 +1137 2.95 3.45 63.75 -0.0206674 -0.214642 0.0205493 0.0137967 0.214624 -0.0137863 0.0 +1138 2.95 3.45 71.25 -0.0266153 -0.192791 0.0266153 -0.00202341 0.192818 0.00206841 0.0 +1139 2.95 3.45 78.75 -0.01303 -0.158177 0.0130391 -0.00963045 0.158217 0.00964696 0.0 +1140 2.95 3.45 86.25 -0.00222429 -0.0960735 0.0021395 -0.0105039 0.0961189 0.0105017 0.0 +1141 2.95 3.45 93.75 0.00366176 -0.0280042 -0.00362622 -0.0130186 0.0279556 0.0130227 0.0 +1142 2.95 3.45 101.25 0.0105055 0.0297138 -0.0104632 -0.0119289 -0.0296664 0.0119117 0.0 +1143 2.95 3.45 108.75 0.0148087 0.0656952 -0.0147408 -0.00665645 -0.0657398 0.0066868 0.0 +1144 2.95 3.45 116.25 0.0114932 0.0726041 -0.0116021 -0.00156607 -0.0726457 0.00154858 0.0 +1145 2.95 3.45 123.75 0.00309518 0.0572911 -0.00312058 0.00244903 -0.0572973 -0.00247607 0.0 +1146 2.95 3.45 131.25 -0.00423195 0.0348253 0.00428653 0.0058355 -0.0347892 -0.0058315 0.0 +1147 2.95 3.45 138.75 -0.00866474 0.0124609 0.00861874 0.00825108 -0.0125166 -0.00826851 0.0 +1148 2.95 3.45 146.25 -0.0145607 -0.0144555 0.0146647 0.0107256 0.0144883 -0.0106962 0.0 +1149 2.95 3.45 153.75 -0.0287837 -0.0532811 0.0286297 0.0157047 0.0531415 -0.0156193 0.0 +1150 2.95 3.45 161.25 -0.0515253 -0.102148 0.0515477 0.0240732 0.102183 -0.0241063 0.0 +1151 2.95 3.45 168.75 -0.0767337 -0.148935 0.0767439 0.0334601 0.1489 -0.0334712 0.0 +1152 2.95 3.45 176.25 -0.0932086 -0.17774 0.0931942 0.0396944 0.177763 -0.0397001 0.0 +1153 2.95 3.55 3.75 9.21891 55.9716 -9.21891 1053.07 -55.9716 -1053.07 0.0 +1154 2.95 3.55 11.25 12.0915 26.8507 -12.0915 505.759 -26.8507 -505.759 0.0 +1155 2.95 3.55 18.75 10.5932 5.25111 -10.5932 161.202 -5.25111 -161.202 0.0 +1156 2.95 3.55 26.25 5.832 -0.960922 -5.83198 35.2215 0.960912 -35.2215 0.0 +1157 2.95 3.55 33.75 1.90632 -0.606111 -1.90629 4.63776 0.606103 -4.63776 0.0 +1158 2.95 3.55 41.25 0.243995 0.00564805 -0.243998 0.296232 -0.00567539 -0.296199 0.0 +1159 2.95 3.55 48.75 -0.0591471 -0.00860415 0.0591375 0.0274887 0.00861739 -0.0274844 0.0 +1160 2.95 3.55 56.25 -0.0269926 -0.0691277 0.0269968 0.0114055 0.0691244 -0.0114149 0.0 +1161 2.95 3.55 63.75 -0.00607235 -0.0689444 0.00606736 0.00520628 0.0689476 -0.00519972 0.0 +1162 2.95 3.55 71.25 -0.00320545 -0.0714308 0.00319651 0.00162512 0.0714338 -0.00162543 0.0 +1163 2.95 3.55 78.75 -0.000709974 -0.0611886 0.00068591 -0.000332506 0.0611933 0.00033069 0.0 +1164 2.95 3.55 86.25 -0.00172169 -0.0350745 0.00168824 -0.00153632 0.035038 0.00153626 0.0 +1165 2.95 3.55 93.75 -0.00504304 -0.0114154 0.00501691 -0.001532 0.0114067 0.0015284 0.0 +1166 2.95 3.55 101.25 -0.00419399 0.00690274 0.00423812 -0.00070908 -0.00693605 0.000712363 0.0 +1167 2.95 3.55 108.75 0.00145246 0.0217666 -0.00146955 -0.00136473 -0.0217677 0.00136709 0.0 +1168 2.95 3.55 116.25 0.00646822 0.0283925 -0.00648991 -0.0023095 -0.0283929 0.00231683 0.0 +1169 2.95 3.55 123.75 0.0071676 0.0255024 -0.00717304 -0.00117394 -0.0255343 0.00118872 0.0 +1170 2.95 3.55 131.25 0.00551051 0.0191405 -0.00553503 0.000805702 -0.0191302 -0.000807014 0.0 +1171 2.95 3.55 138.75 0.00491972 0.0139924 -0.00492367 0.00107791 -0.0140157 -0.00107725 0.0 +1172 2.95 3.55 146.25 0.00468329 0.0079675 -0.00466349 9.16014e-06 -0.0079586 -7.70033e-06 0.0 +1173 2.95 3.55 153.75 0.00109992 -0.00389049 -0.00104878 0.000299902 0.00394253 -0.000326509 0.0 +1174 2.95 3.55 161.25 -0.0078958 -0.022461 0.00792024 0.0035239 0.0224411 -0.0035224 0.0 +1175 2.95 3.55 168.75 -0.019444 -0.0423078 0.0194506 0.00839838 0.0423256 -0.00840352 0.0 +1176 2.95 3.55 176.25 -0.0275442 -0.0551633 0.0275625 0.011971 0.0551683 -0.0119705 0.0 +1177 2.95 3.65 3.75 7.06704 4.57331 -7.06704 82.2836 -4.57331 -82.2836 0.0 +1178 2.95 3.65 11.25 5.4451 1.75617 -5.4451 41.4025 -1.75617 -41.4025 0.0 +1179 2.95 3.65 18.75 3.205 -0.181937 -3.205 13.315 0.181936 -13.315 0.0 +1180 2.95 3.65 26.25 1.3884 -0.45091 -1.3884 2.87287 0.450911 -2.87287 0.0 +1181 2.95 3.65 33.75 0.399535 -0.156162 -0.399534 0.408566 0.156164 -0.408568 0.0 +1182 2.95 3.65 41.25 0.0474327 0.000325414 -0.0474365 0.0559439 -0.000322232 -0.0559436 0.0 +1183 2.95 3.65 48.75 -0.0167623 0.0148239 0.0167622 0.0118571 -0.0148242 -0.011857 0.0 +1184 2.95 3.65 56.25 -0.00966538 0.00961204 0.00966566 0.000613902 -0.00961345 -0.000615629 0.0 +1185 2.95 3.65 63.75 -0.0018771 0.00670523 0.00187471 0.000440809 -0.00670146 -0.000440008 0.0 +1186 2.95 3.65 71.25 -0.000281351 0.00228719 0.000284629 0.00150972 -0.00228777 -0.00150899 0.0 +1187 2.95 3.65 78.75 -0.000573671 0.000786642 0.000576419 0.00114584 -0.000789663 -0.00114555 0.0 +1188 2.95 3.65 86.25 -0.00114618 0.000614687 0.00115016 0.000658531 -0.000610215 -0.000658224 0.0 +1189 2.95 3.65 93.75 -0.0014843 -0.00108906 0.00148416 0.000686066 0.00108644 -0.000685896 0.0 +1190 2.95 3.65 101.25 -0.000744824 -0.00226437 0.000742569 0.000394 0.00226277 -0.000394553 0.0 +1191 2.95 3.65 108.75 0.000733179 -0.00144773 -0.000733097 -0.000392875 0.00144773 0.000393178 0.0 +1192 2.95 3.65 116.25 0.00137293 -0.00049035 -0.00137606 -0.000632154 0.000487911 0.000633826 0.0 +1193 2.95 3.65 123.75 0.000493895 -0.000912215 -0.00049636 8.38473e-05 0.000900696 -7.85158e-05 0.0 +1194 2.95 3.65 131.25 -0.000825425 -0.0018564 0.000824058 0.000856545 0.00185558 -0.000856062 0.0 +1195 2.95 3.65 138.75 -0.00108814 -0.00180504 0.00109441 0.000819354 0.00179515 -0.000812508 0.0 +1196 2.95 3.65 146.25 1.93775e-05 -0.000479276 -1.65839e-05 0.000158438 0.000470583 -0.000154836 0.0 +1197 2.95 3.65 153.75 0.00166473 0.00127079 -0.00166242 -0.000315957 -0.00126902 0.00031561 0.0 +1198 2.95 3.65 161.25 0.00284097 0.00252966 -0.00283858 -0.000108367 -0.00252762 0.000107593 0.0 +1199 2.95 3.65 168.75 0.00323364 0.00305014 -0.00322845 0.000583253 -0.00304442 -0.000587227 0.0 +1200 2.95 3.65 176.25 0.00320119 0.00313431 -0.00320683 0.0011639 -0.00314025 -0.00116103 0.0 +1201 3.05 3.05 3.75 -1202.39 -470.365 1202.39 24403 470.365 -24403 0.0 +1202 3.05 3.05 11.25 -668.169 -316.378 668.169 5239.8 316.378 -5239.8 0.0 +1203 3.05 3.05 18.75 -281.731 -159.304 281.731 1455.24 159.304 -1455.24 0.0 +1204 3.05 3.05 26.25 -82.2316 -55.9751 82.2316 322.339 55.9751 -322.339 0.0 +1205 3.05 3.05 33.75 -13.2072 -11.7376 13.2072 43.2474 11.7377 -43.2475 0.0 +1206 3.05 3.05 41.25 -0.23727 -0.951403 0.237225 1.56363 0.951413 -1.56361 0.0 +1207 3.05 3.05 48.75 -0.165939 -0.246228 0.165967 0.206541 0.24613 -0.206511 0.0 +1208 3.05 3.05 56.25 -0.436043 -0.410636 0.436083 0.304896 0.410632 -0.304963 0.0 +1209 3.05 3.05 63.75 -0.30763 -0.310295 0.307609 0.0679989 0.310281 -0.0680052 0.0 +1210 3.05 3.05 71.25 -0.206649 -0.205757 0.206684 -0.0143256 0.20578 0.0143312 0.0 +1211 3.05 3.05 78.75 -0.11617 -0.112842 0.116269 -0.0611922 0.112662 0.0611357 0.0 +1212 3.05 3.05 86.25 -0.029379 -0.026893 0.0293335 -0.0825493 0.0270606 0.0825471 0.0 +1213 3.05 3.05 93.75 0.0356369 0.0385347 -0.0355095 -0.077343 -0.0385093 0.0773448 0.0 +1214 3.05 3.05 101.25 0.0825754 0.0864857 -0.0826079 -0.0638125 -0.0866197 0.0638187 0.0 +1215 3.05 3.05 108.75 0.102049 0.105697 -0.102052 -0.0415323 -0.105879 0.0415234 0.0 +1216 3.05 3.05 116.25 0.0810613 0.0846985 -0.0811354 -0.00976694 -0.0847927 0.00982253 0.0 +1217 3.05 3.05 123.75 0.0328587 0.0382796 -0.0327086 0.0205591 -0.0383158 -0.0204996 0.0 +1218 3.05 3.05 131.25 -0.0175676 -0.00884341 0.0174819 0.0399706 0.00881225 -0.0399405 0.0 +1219 3.05 3.05 138.75 -0.0618523 -0.0507538 0.0617807 0.050519 0.0510671 -0.0507029 0.0 +1220 3.05 3.05 146.25 -0.112984 -0.102557 0.112876 0.062213 0.102547 -0.0622186 0.0 +1221 3.05 3.05 153.75 -0.183953 -0.177566 0.184157 0.0833769 0.177745 -0.0834765 0.0 +1222 3.05 3.05 161.25 -0.271208 -0.270479 0.271245 0.113891 0.27054 -0.113888 0.0 +1223 3.05 3.05 168.75 -0.353042 -0.357989 0.353053 0.145016 0.357905 -0.145054 0.0 +1224 3.05 3.05 176.25 -0.402759 -0.411064 0.402707 0.164734 0.411172 -0.164821 0.0 +1225 3.05 3.15 3.75 -1005.86 -194.498 1005.86 20622.3 194.498 -20622.3 0.0 +1226 3.05 3.15 11.25 -566.091 -160.869 566.091 4886.81 160.869 -4886.81 0.0 +1227 3.05 3.15 18.75 -240.287 -91.2699 240.287 1363.35 91.2699 -1363.35 0.0 +1228 3.05 3.15 26.25 -72.1732 -33.8748 72.1732 302.315 33.8748 -302.315 0.0 +1229 3.05 3.15 33.75 -13.3946 -6.76814 13.3946 41.8615 6.76815 -41.8615 0.0 +1230 3.05 3.15 41.25 -1.23842 -0.233142 1.2384 2.17485 0.233108 -2.17487 0.0 +1231 3.05 3.15 48.75 -0.292521 -0.178012 0.292534 0.218004 0.177961 -0.217937 0.0 +1232 3.05 3.15 56.25 -0.284809 -0.428332 0.284868 0.232091 0.428389 -0.232079 0.0 +1233 3.05 3.15 63.75 -0.220727 -0.340585 0.220826 0.0743496 0.340452 -0.0743638 0.0 +1234 3.05 3.15 71.25 -0.169662 -0.229028 0.169575 -0.00422416 0.228937 0.00423996 0.0 +1235 3.05 3.15 78.75 -0.0951492 -0.138864 0.0951079 -0.0524268 0.138897 0.0524133 0.0 +1236 3.05 3.15 86.25 -0.0249568 -0.057734 0.0249618 -0.0648182 0.0578461 0.0648357 0.0 +1237 3.05 3.15 93.75 0.0258392 0.0131362 -0.0256859 -0.0587348 -0.0128765 0.058722 0.0 +1238 3.05 3.15 101.25 0.0643498 0.0683206 -0.0643807 -0.0481836 -0.0685476 0.0481991 0.0 +1239 3.05 3.15 108.75 0.0794928 0.0928215 -0.0794856 -0.02838 -0.0927884 0.0283377 0.0 +1240 3.05 3.15 116.25 0.0621262 0.0783423 -0.0619376 -0.00193475 -0.0783081 0.00196418 0.0 +1241 3.05 3.15 123.75 0.0258006 0.041661 -0.0259602 0.0203971 -0.0415221 -0.0204713 0.0 +1242 3.05 3.15 131.25 -0.00984299 0.0033761 0.0098454 0.0334746 -0.00365493 -0.0333855 0.0 +1243 3.05 3.15 138.75 -0.0442769 -0.0350514 0.0443307 0.0414554 0.0352449 -0.041497 0.0 +1244 3.05 3.15 146.25 -0.091463 -0.0871559 0.0914155 0.052571 0.0871283 -0.0525267 0.0 +1245 3.05 3.15 153.75 -0.160353 -0.160828 0.160224 0.0723048 0.160761 -0.0723438 0.0 +1246 3.05 3.15 161.25 -0.243335 -0.247674 0.243164 0.0993507 0.247967 -0.0995663 0.0 +1247 3.05 3.15 168.75 -0.318898 -0.326134 0.319007 0.126072 0.32627 -0.126173 0.0 +1248 3.05 3.15 176.25 -0.36419 -0.372832 0.36427 0.142724 0.372732 -0.142595 0.0 +1249 3.05 3.25 3.75 -707.917 46.1555 707.917 14705.3 -46.1555 -14705.3 0.0 +1250 3.05 3.25 11.25 -403.239 -21.7092 403.239 4225.41 21.7092 -4225.41 0.0 +1251 3.05 3.25 18.75 -168.322 -33.4945 168.322 1198.15 33.4945 -1198.15 0.0 +1252 3.05 3.25 26.25 -49.4611 -17.619 49.4611 265.09 17.619 -265.09 0.0 +1253 3.05 3.25 33.75 -9.19503 -4.34197 9.19508 37.0193 4.34196 -37.0193 0.0 +1254 3.05 3.25 41.25 -0.984275 -0.283052 0.984305 2.13686 0.283053 -2.13689 0.0 +1255 3.05 3.25 48.75 -0.18842 -0.24192 0.188469 0.12944 0.241853 -0.129426 0.0 +1256 3.05 3.25 56.25 -0.14452 -0.42971 0.144635 0.148393 0.42977 -0.148431 0.0 +1257 3.05 3.25 63.75 -0.142141 -0.341575 0.142225 0.0603106 0.341607 -0.0603114 0.0 +1258 3.05 3.25 71.25 -0.120366 -0.235824 0.120331 -0.00584193 0.236031 0.00590595 0.0 +1259 3.05 3.25 78.75 -0.0648858 -0.155118 0.0648497 -0.0407089 0.155197 0.0406872 0.0 +1260 3.05 3.25 86.25 -0.0170367 -0.0778598 0.0169629 -0.0444295 0.0780579 0.0444343 0.0 +1261 3.05 3.25 93.75 0.0177195 -0.00503444 -0.0176269 -0.0424893 0.00514769 0.042496 0.0 +1262 3.05 3.25 101.25 0.0462891 0.05416 -0.0462865 -0.0373615 -0.0542229 0.0373631 0.0 +1263 3.05 3.25 108.75 0.0573669 0.084333 -0.0573216 -0.0224864 -0.0844456 0.0224838 0.0 +1264 3.05 3.25 116.25 0.0451776 0.0795648 -0.0451227 -0.00389795 -0.0795657 0.00392705 0.0 +1265 3.05 3.25 123.75 0.0215897 0.0526945 -0.021368 0.0103573 -0.0529347 -0.010223 0.0 +1266 3.05 3.25 131.25 -0.00169711 0.0202141 0.00167047 0.0191787 -0.0203379 -0.0191286 0.0 +1267 3.05 3.25 138.75 -0.0264021 -0.0159575 0.0263373 0.0263274 0.0160538 -0.0263645 0.0 +1268 3.05 3.25 146.25 -0.0639974 -0.0644796 0.063985 0.0366322 0.0642138 -0.0364741 0.0 +1269 3.05 3.25 153.75 -0.119886 -0.129575 0.119896 0.0530471 0.129703 -0.0531036 0.0 +1270 3.05 3.25 161.25 -0.186549 -0.203618 0.186351 0.0742664 0.20364 -0.0742798 0.0 +1271 3.05 3.25 168.75 -0.246276 -0.269152 0.246288 0.0946959 0.269294 -0.0948405 0.0 +1272 3.05 3.25 176.25 -0.281602 -0.307458 0.281688 0.107277 0.307531 -0.107285 0.0 +1273 3.05 3.35 3.75 -365.113 209.441 365.113 9554.04 -209.441 -9554.04 0.0 +1274 3.05 3.35 11.25 -204.246 81.0767 204.246 3280.1 -81.0766 -3280.1 0.0 +1275 3.05 3.35 18.75 -79.3542 9.6114 79.3542 951.267 -9.61141 -951.267 0.0 +1276 3.05 3.35 26.25 -20.8335 -5.94072 20.8335 209.249 5.9407 -209.249 0.0 +1277 3.05 3.35 33.75 -3.39742 -2.81825 3.39744 28.9771 2.81824 -28.9771 0.0 +1278 3.05 3.35 41.25 -0.403877 -0.37604 0.403872 1.67216 0.375997 -1.67217 0.0 +1279 3.05 3.35 48.75 -0.0863015 -0.268756 0.0862503 0.0304183 0.2687 -0.0303612 0.0 +1280 3.05 3.35 56.25 -0.0467076 -0.385723 0.0467254 0.0764897 0.385756 -0.0765678 0.0 +1281 3.05 3.35 63.75 -0.0765137 -0.296157 0.076492 0.0332949 0.296254 -0.033302 0.0 +1282 3.05 3.35 71.25 -0.0737102 -0.217777 0.0736319 -0.011919 0.217711 0.0118976 0.0 +1283 3.05 3.35 78.75 -0.0386226 -0.164005 0.0385937 -0.0252131 0.164091 0.0252167 0.0 +1284 3.05 3.35 86.25 -0.00860859 -0.0968502 0.00848829 -0.0245854 0.0969682 0.0245984 0.0 +1285 3.05 3.35 93.75 0.0147737 -0.0236231 -0.0147163 -0.0288229 0.0237517 0.0288162 0.0 +1286 3.05 3.35 101.25 0.0330742 0.0394288 -0.0329504 -0.0272844 -0.0394857 0.0273121 0.0 +1287 3.05 3.35 108.75 0.0377886 0.0770313 -0.0378089 -0.0166062 -0.0771797 0.0166531 0.0 +1288 3.05 3.35 116.25 0.0269164 0.0808568 -0.0269524 -0.00526022 -0.0808528 0.00523792 0.0 +1289 3.05 3.35 123.75 0.00994602 0.0605897 -0.00992017 0.00301009 -0.06072 -0.00291031 0.0 +1290 3.05 3.35 131.25 -0.00533206 0.0321631 0.00513532 0.00937287 -0.0322053 -0.00941624 0.0 +1291 3.05 3.35 138.75 -0.0198079 0.00170782 0.0198683 0.0152825 -0.00186433 -0.0152538 0.0 +1292 3.05 3.35 146.25 -0.0421542 -0.0369206 0.0421364 0.0228346 0.0366588 -0.0227076 0.0 +1293 3.05 3.35 153.75 -0.0772172 -0.0895244 0.0772434 0.0344402 0.0896002 -0.0344561 0.0 +1294 3.05 3.35 161.25 -0.121604 -0.151599 0.12161 0.0498996 0.151602 -0.0499331 0.0 +1295 3.05 3.35 168.75 -0.163376 -0.208149 0.163288 0.0652244 0.208133 -0.0652161 0.0 +1296 3.05 3.35 176.25 -0.188553 -0.242014 0.18862 0.0748184 0.241996 -0.0748296 0.0 +1297 3.05 3.45 3.75 -49.0063 211.636 49.0063 4534.02 -211.636 -4534.02 0.0 +1298 3.05 3.45 11.25 -16.2879 99.9048 16.2879 1783.56 -99.9048 -1783.56 0.0 +1299 3.05 3.45 18.75 1.92371 24.1588 -1.92369 528.913 -24.1588 -528.913 0.0 +1300 3.05 3.45 26.25 3.92081 0.239734 -3.92085 114.895 -0.239708 -114.895 0.0 +1301 3.05 3.45 33.75 1.33681 -1.29813 -1.33683 15.4468 1.29814 -15.4467 0.0 +1302 3.05 3.45 41.25 0.0515692 -0.168192 -0.0515773 0.808296 0.168187 -0.808324 0.0 +1303 3.05 3.45 48.75 -0.0454932 -0.172325 0.0455576 -0.0119284 0.172203 0.0119136 0.0 +1304 3.05 3.45 56.25 -0.00725921 -0.261217 0.00720111 0.0402311 0.261254 -0.040187 0.0 +1305 3.05 3.45 63.75 -0.0304125 -0.195611 0.0304302 0.0163773 0.195633 -0.0163835 0.0 +1306 3.05 3.45 71.25 -0.0332991 -0.159008 0.0333114 -0.00806962 0.159016 0.00804613 0.0 +1307 3.05 3.45 78.75 -0.0178735 -0.133654 0.0179131 -0.00824974 0.13361 0.00825353 0.0 +1308 3.05 3.45 86.25 -0.00502976 -0.0823886 0.00511234 -0.00794398 0.0823682 0.00794143 0.0 +1309 3.05 3.45 93.75 0.00414406 -0.0240697 -0.00419551 -0.0119802 0.0240974 0.0119811 0.0 +1310 3.05 3.45 101.25 0.0110567 0.0255518 -0.0111244 -0.0104323 -0.025573 0.0104402 0.0 +1311 3.05 3.45 108.75 0.0138462 0.0574772 -0.013883 -0.00606324 -0.0575893 0.00608259 0.0 +1312 3.05 3.45 116.25 0.011077 0.0635865 -0.0110606 -0.00305434 -0.0635874 0.00307944 0.0 +1313 3.05 3.45 123.75 0.00449426 0.0488256 -0.00448388 0.000439858 -0.0487677 -0.000429246 0.0 +1314 3.05 3.45 131.25 -0.0019067 0.0282409 0.0019165 0.0047807 -0.028183 -0.00479583 0.0 +1315 3.05 3.45 138.75 -0.00725526 0.00817585 0.0071253 0.00823976 -0.0082291 -0.00826636 0.0 +1316 3.05 3.45 146.25 -0.0164527 -0.017166 0.0163605 0.0119186 0.0170814 -0.0118721 0.0 +1317 3.05 3.45 153.75 -0.0355769 -0.0560084 0.0355731 0.0191433 0.0558956 -0.0190579 0.0 +1318 3.05 3.45 161.25 -0.0646594 -0.106219 0.0647645 0.0307881 0.106203 -0.0308022 0.0 +1319 3.05 3.45 168.75 -0.0953586 -0.154516 0.0954731 0.0434057 0.154565 -0.0434184 0.0 +1320 3.05 3.45 176.25 -0.115325 -0.184291 0.11528 0.0516029 0.184203 -0.0515372 0.0 +1321 3.05 3.55 3.75 58.2865 95.694 -58.2865 1303.18 -95.694 -1303.18 0.0 +1322 3.05 3.55 11.25 43.7842 47.0725 -43.7842 564.702 -47.0725 -564.702 0.0 +1323 3.05 3.55 18.75 24.1468 11.6001 -24.1468 170.104 -11.6002 -170.104 0.0 +1324 3.05 3.55 26.25 9.2032 0.165595 -9.2032 36.0656 -0.165608 -36.0656 0.0 +1325 3.05 3.55 33.75 2.10018 -0.495089 -2.10018 4.59251 0.495098 -4.5925 0.0 +1326 3.05 3.55 41.25 0.159888 0.0314295 -0.159875 0.213805 -0.0314347 -0.213825 0.0 +1327 3.05 3.55 48.75 -0.0316332 -0.0209589 0.0316297 0.0113881 0.020965 -0.011392 0.0 +1328 3.05 3.55 56.25 -0.00590874 -0.08247 0.00589294 0.029912 0.0824799 -0.0299018 0.0 +1329 3.05 3.55 63.75 -0.00460387 -0.0639712 0.00458972 0.0134455 0.0639916 -0.0134371 0.0 +1330 3.05 3.55 71.25 -0.00323754 -0.0605657 0.00327371 0.00123371 0.0605309 -0.00124148 0.0 +1331 3.05 3.55 78.75 -0.000975075 -0.0526099 0.000959984 0.00021812 0.052629 -0.000218025 0.0 +1332 3.05 3.55 86.25 -0.00152766 -0.0304211 0.00152531 -0.000124893 0.0304344 0.000128979 0.0 +1333 3.05 3.55 93.75 -0.00281045 -0.0103052 0.00282543 -0.000164696 0.0103138 0.000165631 0.0 +1334 3.05 3.55 101.25 -0.000794283 0.00655645 0.00082915 9.05452e-05 -0.0065146 -9.18973e-05 0.0 +1335 3.05 3.55 108.75 0.0048571 0.0208882 -0.00483972 -0.00172205 -0.020898 0.00171912 0.0 +1336 3.05 3.55 116.25 0.00910593 0.0261263 -0.00910381 -0.00286916 -0.026165 0.00289949 0.0 +1337 3.05 3.55 123.75 0.00835341 0.0213906 -0.00837047 -0.000577344 -0.0213633 0.000556754 0.0 +1338 3.05 3.55 131.25 0.00484672 0.0140179 -0.00483896 0.00261085 -0.0140112 -0.00259889 0.0 +1339 3.05 3.55 138.75 0.00145793 0.00803444 -0.00146708 0.00365082 -0.00802698 -0.00365445 0.0 +1340 3.05 3.55 146.25 -0.00319952 -0.000185068 0.00323208 0.00391313 0.000156672 -0.00387595 0.0 +1341 3.05 3.55 153.75 -0.0136071 -0.0160629 0.0136006 0.0069895 0.0160638 -0.00699597 0.0 +1342 3.05 3.55 161.25 -0.0307544 -0.0391932 0.0307909 0.0140586 0.0392269 -0.0140635 0.0 +1343 3.05 3.55 168.75 -0.0498663 -0.0628118 0.0498782 0.0225481 0.0628021 -0.0225421 0.0 +1344 3.05 3.55 176.25 -0.0625385 -0.0776921 0.0625437 0.0282624 0.0776849 -0.0282597 0.0 +1345 3.05 3.65 3.75 14.7738 9.01288 -14.7738 99.4234 -9.01288 -99.4234 0.0 +1346 3.05 3.65 11.25 10.4256 4.10096 -10.4256 45.9297 -4.10096 -45.9297 0.0 +1347 3.05 3.65 18.75 5.33829 0.564282 -5.33829 13.8766 -0.564281 -13.8766 0.0 +1348 3.05 3.65 26.25 1.92055 -0.318539 -1.92055 2.83407 0.318537 -2.83407 0.0 +1349 3.05 3.65 33.75 0.431842 -0.140656 -0.431843 0.348739 0.140656 -0.348739 0.0 +1350 3.05 3.65 41.25 0.0364247 0.00723669 -0.0364242 0.0264389 -0.00723644 -0.0264393 0.0 +1351 3.05 3.65 48.75 -0.0100345 0.0159315 0.0100318 0.0080024 -0.0159293 -0.00800035 0.0 +1352 3.05 3.65 56.25 -0.00452025 0.00778732 0.00451941 0.00551883 -0.00778686 -0.00552083 0.0 +1353 3.05 3.65 63.75 -0.000672337 0.00521555 0.000670408 0.00280248 -0.00521397 -0.00280318 0.0 +1354 3.05 3.65 71.25 0.000360923 0.00171355 -0.00036216 0.00121365 -0.00171269 -0.00121435 0.0 +1355 3.05 3.65 78.75 6.70805e-05 0.000819412 -6.59271e-05 0.000597606 -0.000817676 -0.000597435 0.0 +1356 3.05 3.65 86.25 -0.00057186 0.000644185 0.000572355 0.000567504 -0.00064307 -0.000567647 0.0 +1357 3.05 3.65 93.75 -0.000751471 -0.00106817 0.000749874 0.000757072 0.00106639 -0.000757055 0.0 +1358 3.05 3.65 101.25 0.000275919 -0.00183009 -0.000275096 0.000255174 0.00183474 -0.00025562 0.0 +1359 3.05 3.65 108.75 0.00189848 -0.000761837 -0.00189497 -0.000636546 0.000759074 0.000637236 0.0 +1360 3.05 3.65 116.25 0.00236351 -0.000115402 -0.00236272 -0.000553323 0.000119324 0.000553044 0.0 +1361 3.05 3.65 123.75 0.00106135 -0.00107726 -0.00106142 0.000592741 0.00108013 -0.000595129 0.0 +1362 3.05 3.65 131.25 -0.000675214 -0.0023987 0.000676951 0.00145629 0.00239971 -0.00145617 0.0 +1363 3.05 3.65 138.75 -0.00134281 -0.00270273 0.00134522 0.00120903 0.00269853 -0.00120659 0.0 +1364 3.05 3.65 146.25 -0.000900174 -0.00203273 0.000901187 0.000435489 0.00203583 -0.00043519 0.0 +1365 3.05 3.65 153.75 -0.000477871 -0.00132233 0.00047692 0.000219008 0.00131769 -0.000216421 0.0 +1366 3.05 3.65 161.25 -0.000970611 -0.00119912 0.000968838 0.000989395 0.00120357 -0.000993014 0.0 +1367 3.05 3.65 168.75 -0.00221265 -0.00158211 0.00221741 0.00227827 0.00158658 -0.00228145 0.0 +1368 3.05 3.65 176.25 -0.00325813 -0.00197769 0.00326165 0.00322864 0.00198236 -0.00323014 0.0 +1369 3.15 3.15 3.75 -956.411 -157.961 956.411 21490.2 157.961 -21490.2 0.0 +1370 3.15 3.15 11.25 -539.133 -158.376 539.133 4570.6 158.376 -4570.6 0.0 +1371 3.15 3.15 18.75 -230.746 -100.448 230.746 1239.08 100.448 -1239.08 0.0 +1372 3.15 3.15 26.25 -69.0286 -41.453 69.0285 264.322 41.4531 -264.322 0.0 +1373 3.15 3.15 33.75 -11.9443 -9.95787 11.9443 34.0693 9.95793 -34.0693 0.0 +1374 3.15 3.15 41.25 -0.582646 -0.953585 0.58261 1.49815 0.953585 -1.49815 0.0 +1375 3.15 3.15 48.75 -0.185725 -0.189058 0.185672 0.262739 0.188971 -0.262688 0.0 +1376 3.15 3.15 56.25 -0.35028 -0.339487 0.350287 0.209512 0.33955 -0.209522 0.0 +1377 3.15 3.15 63.75 -0.251984 -0.259721 0.252092 0.053384 0.25962 -0.0533321 0.0 +1378 3.15 3.15 71.25 -0.171035 -0.17401 0.170979 -0.00382131 0.173971 0.003789 0.0 +1379 3.15 3.15 78.75 -0.103081 -0.108356 0.103106 -0.0377398 0.108153 0.0377189 0.0 +1380 3.15 3.15 86.25 -0.0427632 -0.046394 0.0427713 -0.0466376 0.0463966 0.046639 0.0 +1381 3.15 3.15 93.75 0.00566927 0.00495154 -0.00569908 -0.0428492 -0.00499621 0.0428512 0.0 +1382 3.15 3.15 101.25 0.0504745 0.0463917 -0.0505543 -0.0360707 -0.0464682 0.0360915 0.0 +1383 3.15 3.15 108.75 0.0794281 0.0686813 -0.0795551 -0.0228925 -0.0688457 0.0229235 0.0 +1384 3.15 3.15 116.25 0.0742594 0.061464 -0.0741882 -0.00450275 -0.0615471 0.00449575 0.0 +1385 3.15 3.15 123.75 0.0412054 0.0335455 -0.0410459 0.0122873 -0.0334909 -0.0122658 0.0 +1386 3.15 3.15 131.25 0.00256192 0.00204886 -0.00232937 0.0225283 -0.00204045 -0.0224878 0.0 +1387 3.15 3.15 138.75 -0.0317873 -0.0281822 0.0319935 0.0275685 0.0282669 -0.0275469 0.0 +1388 3.15 3.15 146.25 -0.0711984 -0.0672197 0.0711102 0.0343857 0.0670901 -0.0343675 0.0 +1389 3.15 3.15 153.75 -0.126399 -0.123952 0.126399 0.0498039 0.123889 -0.049802 0.0 +1390 3.15 3.15 161.25 -0.195704 -0.194707 0.195608 0.074158 0.194762 -0.0742025 0.0 +1391 3.15 3.15 168.75 -0.261579 -0.261942 0.261393 0.100026 0.261901 -0.100036 0.0 +1392 3.15 3.15 176.25 -0.301524 -0.302836 0.301604 0.116713 0.302746 -0.116682 0.0 +1393 3.15 3.25 3.75 -650.193 134.226 650.193 17650.1 -134.226 -17650.1 0.0 +1394 3.15 3.25 11.25 -365.979 7.48146 365.979 4109.37 -7.48145 -4109.37 0.0 +1395 3.15 3.25 18.75 -155.208 -30.119 155.208 1115.3 30.119 -1115.3 0.0 +1396 3.15 3.25 26.25 -46.6783 -20.0797 46.6784 237.228 20.0796 -237.228 0.0 +1397 3.15 3.25 33.75 -8.72374 -5.70064 8.7238 31.186 5.70056 -31.186 0.0 +1398 3.15 3.25 41.25 -0.780005 -0.490403 0.779991 1.61053 0.490338 -1.61049 0.0 +1399 3.15 3.25 48.75 -0.160056 -0.188506 0.160035 0.172817 0.188447 -0.172832 0.0 +1400 3.15 3.25 56.25 -0.197253 -0.356173 0.197337 0.156424 0.35612 -0.156432 0.0 +1401 3.15 3.25 63.75 -0.16741 -0.265816 0.167365 0.0571964 0.265815 -0.0571946 0.0 +1402 3.15 3.25 71.25 -0.130237 -0.184874 0.130267 0.00234427 0.184786 -0.0023759 0.0 +1403 3.15 3.25 78.75 -0.0843061 -0.129234 0.0843542 -0.022381 0.129426 0.0223457 0.0 +1404 3.15 3.25 86.25 -0.03979 -0.0657959 0.0398035 -0.0277737 0.0658759 0.0277741 0.0 +1405 3.15 3.25 93.75 -0.00238909 -0.00774928 0.00240125 -0.0282358 0.00785304 0.028235 0.0 +1406 3.15 3.25 101.25 0.0303823 0.0357636 -0.0303854 -0.0222829 -0.0356794 0.0222854 0.0 +1407 3.15 3.25 108.75 0.0506977 0.0585556 -0.0506894 -0.0102554 -0.0584086 0.0102105 0.0 +1408 3.15 3.25 116.25 0.0502104 0.0558613 -0.050186 0.00160465 -0.0559321 -0.00157822 0.0 +1409 3.15 3.25 123.75 0.0345455 0.035523 -0.0344902 0.0104005 -0.0355763 -0.0103987 0.0 +1410 3.15 3.25 131.25 0.0151486 0.0110531 -0.015251 0.0158941 -0.0112994 -0.0157901 0.0 +1411 3.15 3.25 138.75 -0.0050971 -0.013565 0.00511178 0.019016 0.013684 -0.0190174 0.0 +1412 3.15 3.25 146.25 -0.0345021 -0.0459216 0.0345176 0.0233695 0.0459787 -0.0233686 0.0 +1413 3.15 3.25 153.75 -0.0793413 -0.0928252 0.079314 0.0332493 0.092565 -0.033146 0.0 +1414 3.15 3.25 161.25 -0.134603 -0.150218 0.13452 0.0491025 0.150129 -0.0490542 0.0 +1415 3.15 3.25 168.75 -0.18553 -0.204163 0.185623 0.0660649 0.204474 -0.0662343 0.0 +1416 3.15 3.25 176.25 -0.216402 -0.237045 0.216252 0.0770174 0.237253 -0.0771667 0.0 +1417 3.15 3.35 3.75 -275.127 338.879 275.127 11754.8 -338.879 -11754.8 0.0 +1418 3.15 3.35 11.25 -149.928 134.982 149.928 3283.86 -134.982 -3283.86 0.0 +1419 3.15 3.35 18.75 -59.9126 24.6097 59.9126 901.613 -24.6098 -901.613 0.0 +1420 3.15 3.35 26.25 -17.3899 -3.93464 17.3899 190.736 3.93463 -190.736 0.0 +1421 3.15 3.35 33.75 -3.54567 -2.80737 3.54565 25.2257 2.80735 -25.2256 0.0 +1422 3.15 3.35 41.25 -0.5028 -0.297045 0.502764 1.39094 0.297079 -1.39098 0.0 +1423 3.15 3.35 48.75 -0.0786613 -0.21351 0.0785848 0.0781363 0.213592 -0.0781848 0.0 +1424 3.15 3.35 56.25 -0.0749822 -0.340141 0.0749439 0.0885512 0.340151 -0.0884967 0.0 +1425 3.15 3.35 63.75 -0.0903085 -0.233796 0.0902789 0.0251462 0.233735 -0.0251422 0.0 +1426 3.15 3.35 71.25 -0.0742191 -0.168217 0.0742917 -0.0123034 0.168118 0.0122774 0.0 +1427 3.15 3.35 78.75 -0.0442502 -0.131009 0.0441129 -0.0159319 0.131038 0.0159283 0.0 +1428 3.15 3.35 86.25 -0.0140131 -0.074057 0.0140325 -0.0175558 0.0741452 0.0175633 0.0 +1429 3.15 3.35 93.75 0.0107044 -0.016984 -0.0107096 -0.0224514 0.0169392 0.0224516 0.0 +1430 3.15 3.35 101.25 0.0273468 0.0283944 -0.0273571 -0.0182899 -0.0285471 0.0182767 0.0 +1431 3.15 3.35 108.75 0.0341621 0.05763 -0.0342268 -0.00978414 -0.0577058 0.00979257 0.0 +1432 3.15 3.35 116.25 0.0303908 0.0623219 -0.030319 -0.00386081 -0.0623156 0.00386282 0.0 +1433 3.15 3.35 123.75 0.0193498 0.0473473 -0.0192958 0.00117491 -0.0471971 -0.0012989 0.0 +1434 3.15 3.35 131.25 0.00780853 0.0276758 -0.00776157 0.00608841 -0.0275645 -0.00615459 0.0 +1435 3.15 3.35 138.75 -0.00281951 0.00980171 0.0028173 0.00899561 -0.0103754 -0.00875617 0.0 +1436 3.15 3.35 146.25 -0.0177849 -0.0122083 0.0178591 0.0111587 0.0120863 -0.0110729 0.0 +1437 3.15 3.35 153.75 -0.0428755 -0.0468128 0.0427986 0.0164875 0.0467219 -0.0164577 0.0 +1438 3.15 3.35 161.25 -0.0757418 -0.0922436 0.0757394 0.0263114 0.0922185 -0.0263166 0.0 +1439 3.15 3.35 168.75 -0.107642 -0.136426 0.107584 0.0374315 0.136228 -0.0373364 0.0 +1440 3.15 3.35 176.25 -0.127132 -0.16362 0.127062 0.0447389 0.163558 -0.0447096 0.0 +1441 3.15 3.45 3.75 46.6657 326.302 -46.6657 5480.32 -326.302 -5480.32 0.0 +1442 3.15 3.45 11.25 39.3764 154.267 -39.3764 1815.17 -154.267 -1815.17 0.0 +1443 3.15 3.45 18.75 22.0244 42.3138 -22.0244 505.91 -42.3138 -505.91 0.0 +1444 3.15 3.45 26.25 7.29371 4.3406 -7.29372 105.668 -4.3406 -105.668 0.0 +1445 3.15 3.45 33.75 0.914334 -0.603679 -0.914334 13.7287 0.603677 -13.7287 0.0 +1446 3.15 3.45 41.25 -0.158065 -0.0326246 0.158056 0.711344 0.0326778 -0.711315 0.0 +1447 3.15 3.45 48.75 -0.0159738 -0.166204 0.0159671 0.0133403 0.16615 -0.0133219 0.0 +1448 3.15 3.45 56.25 -0.00488119 -0.253233 0.00491148 0.0471634 0.253244 -0.0471562 0.0 +1449 3.15 3.45 63.75 -0.0387289 -0.159738 0.0387929 0.00737726 0.159718 -0.00733701 0.0 +1450 3.15 3.45 71.25 -0.0342167 -0.123108 0.0342095 -0.0134089 0.123119 0.0133794 0.0 +1451 3.15 3.45 78.75 -0.0183889 -0.107233 0.0183971 -0.00702141 0.10719 0.00700092 0.0 +1452 3.15 3.45 86.25 -0.00224304 -0.0672358 0.00223149 -0.00740458 0.06732 0.00740179 0.0 +1453 3.15 3.45 93.75 0.00883338 -0.0235886 -0.00886164 -0.0107045 0.0235433 0.0107089 0.0 +1454 3.15 3.45 101.25 0.0123235 0.015828 -0.012348 -0.00762384 -0.0158064 0.00760398 0.0 +1455 3.15 3.45 108.75 0.0118714 0.0452165 -0.0118843 -0.00509858 -0.0451645 0.00505638 0.0 +1456 3.15 3.45 116.25 0.00859034 0.0531575 -0.00865278 -0.00443542 -0.0532255 0.00444204 0.0 +1457 3.15 3.45 123.75 0.00258788 0.0423716 -0.00256692 -0.00117868 -0.0424366 0.00121603 0.0 +1458 3.15 3.45 131.25 -0.00267606 0.0273421 0.00253797 0.00313079 -0.0273467 -0.00313102 0.0 +1459 3.15 3.45 138.75 -0.00458018 0.0145732 0.00460276 0.00490419 -0.0145389 -0.00492224 0.0 +1460 3.15 3.45 146.25 -0.00839922 -0.00315912 0.00836753 0.00593978 0.00307101 -0.00589991 0.0 +1461 3.15 3.45 153.75 -0.0209444 -0.0338477 0.020904 0.0108714 0.0337667 -0.0108179 0.0 +1462 3.15 3.45 161.25 -0.0433497 -0.0756648 0.043318 0.020838 0.0757092 -0.0208768 0.0 +1463 3.15 3.45 168.75 -0.0683875 -0.116448 0.0683041 0.0321496 0.116416 -0.0321632 0.0 +1464 3.15 3.45 176.25 -0.0847651 -0.141502 0.0847114 0.0395279 0.141475 -0.0394984 0.0 +1465 3.15 3.55 3.75 113.453 150.898 -113.453 1527.06 -150.898 -1527.06 0.0 +1466 3.15 3.55 11.25 75.6979 75.7027 -75.6979 574.861 -75.7027 -574.861 0.0 +1467 3.15 3.55 18.75 35.5664 22.022 -35.5664 161.502 -22.022 -161.502 0.0 +1468 3.15 3.55 26.25 10.941 2.87256 -10.941 32.6315 -2.87256 -32.6315 0.0 +1469 3.15 3.55 33.75 1.72278 0.0375193 -1.7228 3.93133 -0.0374953 -3.93134 0.0 +1470 3.15 3.55 41.25 0.0142898 0.108618 -0.0143047 0.136579 -0.108608 -0.136591 0.0 +1471 3.15 3.55 48.75 0.00816166 -0.0380896 -0.00814953 0.010256 0.0380813 -0.0102749 0.0 +1472 3.15 3.55 56.25 0.0124306 -0.0965177 -0.0124185 0.0389722 0.0965193 -0.0389853 0.0 +1473 3.15 3.55 63.75 -0.00596526 -0.0594462 0.00595775 0.0133454 0.0594234 -0.0133421 0.0 +1474 3.15 3.55 71.25 -0.00358192 -0.0502022 0.00356674 -0.001576 0.0502323 0.00155584 0.0 +1475 3.15 3.55 78.75 0.000427233 -0.0447805 -0.000397985 -0.000360659 0.0448087 0.000358663 0.0 +1476 3.15 3.55 86.25 0.00221954 -0.0289613 -0.00224103 0.000309741 0.0290046 -0.000307859 0.0 +1477 3.15 3.55 93.75 0.00167606 -0.0143391 -0.0016639 0.000808733 0.0143451 -0.000807743 0.0 +1478 3.15 3.55 101.25 0.00112826 0.001235 -0.00111313 0.000644257 -0.00118443 -0.000655222 0.0 +1479 3.15 3.55 108.75 0.00330286 0.0161835 -0.00328457 -0.00210868 -0.0161684 0.00210336 0.0 +1480 3.15 3.55 116.25 0.00487387 0.021415 -0.00489745 -0.00297998 -0.0214282 0.00298062 0.0 +1481 3.15 3.55 123.75 0.00293975 0.016899 -0.00293859 0.000267886 -0.0168868 -0.000264266 0.0 +1482 3.15 3.55 131.25 -0.000108452 0.0105143 0.000105308 0.0034128 -0.0105219 -0.00340601 0.0 +1483 3.15 3.55 138.75 -0.0019759 0.00532812 0.00199003 0.00354695 -0.00537804 -0.00353067 0.0 +1484 3.15 3.55 146.25 -0.00603215 -0.00319989 0.00603288 0.00350166 0.0031536 -0.00347955 0.0 +1485 3.15 3.55 153.75 -0.0177873 -0.0194322 0.017795 0.00752565 0.0194683 -0.00752983 0.0 +1486 3.15 3.55 161.25 -0.0380423 -0.0418389 0.038072 0.0161592 0.041823 -0.016153 0.0 +1487 3.15 3.55 168.75 -0.0604183 -0.0634358 0.0604406 0.025925 0.0634577 -0.0259272 0.0 +1488 3.15 3.55 176.25 -0.0751419 -0.0766462 0.0751429 0.0322594 0.0766293 -0.0322626 0.0 +1489 3.15 3.65 3.75 22.6045 15.6092 -22.6045 111.52 -15.6092 -111.52 0.0 +1490 3.15 3.65 11.25 14.9574 7.74254 -14.9574 45.5783 -7.74254 -45.5783 0.0 +1491 3.15 3.65 18.75 6.90511 1.96171 -6.90511 12.5917 -1.96171 -12.5917 0.0 +1492 3.15 3.65 26.25 2.1033 0.0752923 -2.1033 2.33462 -0.0752924 -2.33462 0.0 +1493 3.15 3.65 33.75 0.345582 -0.0501268 -0.345582 0.224112 0.0501278 -0.224114 0.0 +1494 3.15 3.65 41.25 0.0113715 0.0247154 -0.0113732 -0.00142732 -0.0247142 0.00142719 0.0 +1495 3.15 3.65 48.75 6.87534e-06 0.0140289 -8.51151e-06 0.00563543 -0.0140289 -0.00563605 0.0 +1496 3.15 3.65 56.25 0.00107984 0.0029724 -0.00108132 0.0085864 -0.00297002 -0.00858758 0.0 +1497 3.15 3.65 63.75 0.000469516 0.00270845 -0.000469271 0.00350089 -0.00271011 -0.00350175 0.0 +1498 3.15 3.65 71.25 0.00166924 0.00153728 -0.00167029 0.000471675 -0.00153501 -0.000472585 0.0 +1499 3.15 3.65 78.75 0.00174748 0.00147027 -0.00174735 0.000292892 -0.00147097 -0.000293091 0.0 +1500 3.15 3.65 86.25 0.000889203 0.00101364 -0.000888457 0.000849106 -0.00101254 -0.000849064 0.0 +1501 3.15 3.65 93.75 2.8391e-05 -0.000779719 -2.40476e-05 0.00107302 0.000781464 -0.0010731 0.0 +1502 3.15 3.65 101.25 0.000123662 -0.00119237 -0.000121972 0.000258462 0.00119287 -0.000258603 0.0 +1503 3.15 3.65 108.75 0.000918738 -7.37641e-05 -0.000914812 -0.00070731 7.40479e-05 0.000707953 0.0 +1504 3.15 3.65 116.25 0.00087327 0.000204194 -0.000871841 -0.000333298 -0.000200322 0.000333731 0.0 +1505 3.15 3.65 123.75 -0.000487938 -0.000958429 0.000488243 0.000977954 0.000952902 -0.000975387 0.0 +1506 3.15 3.65 131.25 -0.00192454 -0.00214305 0.00192471 0.00156629 0.00213806 -0.00156455 0.0 +1507 3.15 3.65 138.75 -0.00245031 -0.00237129 0.00244858 0.000874281 0.00237286 -0.000874291 0.0 +1508 3.15 3.65 146.25 -0.00267054 -0.00197417 0.00267194 -7.6905e-05 0.00197292 7.72814e-05 0.0 +1509 3.15 3.65 153.75 -0.00396803 -0.00167631 0.00396857 -7.83088e-05 0.00167684 7.95127e-05 0.0 +1510 3.15 3.65 161.25 -0.00685387 -0.0017756 0.00685877 0.001108 0.0017796 -0.00110938 0.0 +1511 3.15 3.65 168.75 -0.0103819 -0.00210183 0.0103815 0.00276801 0.00210519 -0.00277039 0.0 +1512 3.15 3.65 176.25 -0.0127948 -0.0023518 0.0127908 0.00391691 0.00234768 -0.00391514 0.0 +1513 3.25 3.25 3.75 -516.093 207.353 516.093 17519 -207.353 -17519 0.0 +1514 3.25 3.25 11.25 -297.818 30.2999 297.818 3670.93 -30.2999 -3670.93 0.0 +1515 3.25 3.25 18.75 -131.533 -29.3583 131.533 966.016 29.3582 -966.016 0.0 +1516 3.25 3.25 26.25 -41.2561 -23.5547 41.2561 197.399 23.5547 -197.399 0.0 +1517 3.25 3.25 33.75 -7.77181 -7.42064 7.77175 24.324 7.42059 -24.3239 0.0 +1518 3.25 3.25 41.25 -0.520054 -0.786867 0.520059 1.16473 0.786915 -1.16475 0.0 +1519 3.25 3.25 48.75 -0.135385 -0.107324 0.135384 0.176595 0.107322 -0.176651 0.0 +1520 3.25 3.25 56.25 -0.236403 -0.233969 0.236341 0.100092 0.234021 -0.099998 0.0 +1521 3.25 3.25 63.75 -0.177344 -0.160255 0.177338 0.016127 0.160281 -0.0161542 0.0 +1522 3.25 3.25 71.25 -0.134993 -0.110418 0.134999 -0.0109067 0.110353 0.010913 0.0 +1523 3.25 3.25 78.75 -0.0950825 -0.0779897 0.0951253 -0.021928 0.077927 0.0219105 0.0 +1524 3.25 3.25 86.25 -0.0482799 -0.0371325 0.0482478 -0.0253972 0.0372349 0.0254039 0.0 +1525 3.25 3.25 93.75 -0.00935062 -0.00567433 0.00930825 -0.0233964 0.0056727 0.0233906 0.0 +1526 3.25 3.25 101.25 0.0268556 0.0229776 -0.0268747 -0.016636 -0.0229697 0.0166413 0.0 +1527 3.25 3.25 108.75 0.0559475 0.0486988 -0.0559577 -0.010512 -0.0487913 0.0105343 0.0 +1528 3.25 3.25 116.25 0.0599605 0.0541495 -0.0598537 -0.00538128 -0.0541128 0.00538138 0.0 +1529 3.25 3.25 123.75 0.0386584 0.0352012 -0.038683 0.00205185 -0.0351223 -0.00210039 0.0 +1530 3.25 3.25 131.25 0.0113902 0.00756233 -0.0112221 0.0099077 -0.00759024 -0.00983246 0.0 +1531 3.25 3.25 138.75 -0.0116709 -0.0175027 0.0116404 0.0150778 0.0175656 -0.0151232 0.0 +1532 3.25 3.25 146.25 -0.0379372 -0.0440118 0.0378931 0.0202482 0.0440189 -0.0202764 0.0 +1533 3.25 3.25 153.75 -0.0789016 -0.0826345 0.0789715 0.0309487 0.0826604 -0.0309747 0.0 +1534 3.25 3.25 161.25 -0.13326 -0.134571 0.133258 0.0482225 0.134355 -0.0481305 0.0 +1535 3.25 3.25 168.75 -0.185796 -0.186751 0.185766 0.0666972 0.186837 -0.0667545 0.0 +1536 3.25 3.25 176.25 -0.217924 -0.219808 0.217907 0.078575 0.219826 -0.0785566 0.0 +1537 3.25 3.35 3.75 -136.489 468.84 136.489 13261.2 -468.84 -13261.2 0.0 +1538 3.25 3.35 11.25 -76.3677 186.541 76.3677 3006.19 -186.541 -3006.19 0.0 +1539 3.25 3.35 18.75 -34.4387 38.7843 34.4388 785.234 -38.7843 -785.234 0.0 +1540 3.25 3.35 26.25 -12.2064 -2.42532 12.2063 158.413 2.42535 -158.413 0.0 +1541 3.25 3.35 33.75 -3.01753 -3.19124 3.01752 19.5862 3.19127 -19.5862 0.0 +1542 3.25 3.35 41.25 -0.376538 -0.403329 0.376502 0.965951 0.403384 -0.965979 0.0 +1543 3.25 3.35 48.75 -0.0663706 -0.151905 0.066354 0.0762885 0.151928 -0.0763483 0.0 +1544 3.25 3.35 56.25 -0.115811 -0.241426 0.115854 0.0757353 0.241441 -0.0756865 0.0 +1545 3.25 3.35 63.75 -0.10133 -0.1561 0.101333 0.0257088 0.156123 -0.0256754 0.0 +1546 3.25 3.35 71.25 -0.0830317 -0.123866 0.083011 0.00222966 0.123776 -0.00226914 0.0 +1547 3.25 3.35 78.75 -0.0648663 -0.0963338 0.0649114 -0.00193966 0.0962687 0.00191896 0.0 +1548 3.25 3.35 86.25 -0.0348832 -0.0452658 0.0348888 -0.00953403 0.0452114 0.00953002 0.0 +1549 3.25 3.35 93.75 -0.00930256 -0.00606384 0.00931036 -0.0124204 0.00592252 0.0124271 0.0 +1550 3.25 3.35 101.25 0.0100895 0.0236635 -0.0100704 -0.00601918 -0.0236457 0.00599972 0.0 +1551 3.25 3.35 108.75 0.0265883 0.0477513 -0.0265736 -0.00229502 -0.0475016 0.00223504 0.0 +1552 3.25 3.35 116.25 0.0315534 0.0512958 -0.0315658 -0.00201565 -0.0511774 0.00205073 0.0 +1553 3.25 3.35 123.75 0.0223392 0.0342892 -0.0222605 0.00148067 -0.0341723 -0.00152918 0.0 +1554 3.25 3.35 131.25 0.00941799 0.0153327 -0.00949539 0.00600099 -0.015387 -0.00602979 0.0 +1555 3.25 3.35 138.75 0.00192308 0.00676484 -0.0019709 0.00587968 -0.0067599 -0.00587268 0.0 +1556 3.25 3.35 146.25 -0.00390089 0.00228314 0.00390376 0.00216232 -0.00224221 -0.00219 0.0 +1557 3.25 3.35 153.75 -0.0157319 -0.00974298 0.0157634 0.000201998 0.00958756 -0.00010215 0.0 +1558 3.25 3.35 161.25 -0.0344272 -0.0332355 0.0345224 0.00245974 0.0332678 -0.00241767 0.0 +1559 3.25 3.35 168.75 -0.0539332 -0.0604648 0.0538857 0.00692496 0.0604662 -0.00693555 0.0 +1560 3.25 3.35 176.25 -0.0657833 -0.0784772 0.0659121 0.0101981 0.0784511 -0.0101316 0.0 +1561 3.25 3.45 3.75 160.753 453.103 -160.753 6268.16 -453.103 -6268.16 0.0 +1562 3.25 3.45 11.25 98.9204 211.866 -98.9204 1677.08 -211.866 -1677.08 0.0 +1563 3.25 3.45 18.75 41.6475 62.0615 -41.6475 437.04 -62.0615 -437.04 0.0 +1564 3.25 3.45 26.25 10.2776 8.85177 -10.2776 86.3962 -8.85176 -86.3962 0.0 +1565 3.25 3.45 33.75 0.665198 -0.0281349 -0.665216 10.5941 0.0281541 -10.5942 0.0 +1566 3.25 3.45 41.25 -0.225316 -0.0097665 0.225331 0.540446 0.00977707 -0.540423 0.0 +1567 3.25 3.45 48.75 -0.000555537 -0.138966 0.000568013 0.0245727 0.138941 -0.0245583 0.0 +1568 3.25 3.45 56.25 -0.0247081 -0.191676 0.0246253 0.0387653 0.191736 -0.0387721 0.0 +1569 3.25 3.45 63.75 -0.0406244 -0.104835 0.0405644 0.00218269 0.104904 -0.00218938 0.0 +1570 3.25 3.45 71.25 -0.0316041 -0.0868229 0.0315861 -0.00999292 0.086857 0.00997278 0.0 +1571 3.25 3.45 78.75 -0.0244453 -0.0766617 0.0244139 -0.00348801 0.076724 0.00349178 0.0 +1572 3.25 3.45 86.25 -0.00890648 -0.0447902 0.00892778 -0.00721057 0.0446984 0.00720699 0.0 +1573 3.25 3.45 93.75 0.00249213 -0.015882 -0.00250762 -0.00859341 0.0157787 0.00859132 0.0 +1574 3.25 3.45 101.25 0.00593138 0.0124111 -0.00596771 -0.00363029 -0.0123966 0.00362055 0.0 +1575 3.25 3.45 108.75 0.00849249 0.0372762 -0.00846232 -0.00245363 -0.0373616 0.0024942 0.0 +1576 3.25 3.45 116.25 0.00730472 0.0430354 -0.00734682 -0.00257204 -0.0430353 0.00254668 0.0 +1577 3.25 3.45 123.75 0.000252497 0.0319203 -0.000228003 0.00117018 -0.0317262 -0.00121273 0.0 +1578 3.25 3.45 131.25 -0.00509858 0.0202249 0.00511462 0.00424735 -0.0201591 -0.00429141 0.0 +1579 3.25 3.45 138.75 -0.00189225 0.0157697 0.00192964 0.00188411 -0.0157307 -0.00190094 0.0 +1580 3.25 3.45 146.25 0.00595475 0.0116431 -0.0059073 -0.0030478 -0.0116606 0.00308588 0.0 +1581 3.25 3.45 153.75 0.00984054 -0.000318014 -0.00985575 -0.00518825 0.000191851 0.00524895 0.0 +1582 3.25 3.45 161.25 0.00625952 -0.0201284 -0.00627072 -0.00318494 0.0201728 0.00314475 0.0 +1583 3.25 3.45 168.75 -0.00150526 -0.0406308 0.00144698 0.000485931 0.0405933 -0.00047182 0.0 +1584 3.25 3.45 176.25 -0.00732316 -0.0533522 0.00734119 0.00300328 0.0532394 -0.0029465 0.0 +1585 3.25 3.55 3.75 170.017 215.704 -170.017 1682.14 -215.704 -1682.14 0.0 +1586 3.25 3.55 11.25 104.65 108.392 -104.65 523.152 -108.392 -523.152 0.0 +1587 3.25 3.55 18.75 44.2579 34.3622 -44.2579 134.428 -34.3622 -134.428 0.0 +1588 3.25 3.55 26.25 11.5313 6.21431 -11.5313 25.1215 -6.2143 -25.1215 0.0 +1589 3.25 3.55 33.75 1.18823 0.636226 -1.18825 2.77896 -0.636222 -2.77896 0.0 +1590 3.25 3.55 41.25 -0.090997 0.150717 0.0909756 0.0854078 -0.1507 -0.0854088 0.0 +1591 3.25 3.55 48.75 0.0364606 -0.051279 -0.0364402 0.0168919 0.0512661 -0.0168927 0.0 +1592 3.25 3.55 56.25 0.0111486 -0.090247 -0.0111456 0.0363843 0.090261 -0.0363792 0.0 +1593 3.25 3.55 63.75 -0.0105072 -0.0440459 0.0105073 0.00831444 0.0440284 -0.00831955 0.0 +1594 3.25 3.55 71.25 -0.00433658 -0.0361287 0.00434277 -0.00361399 0.0361351 0.00360689 0.0 +1595 3.25 3.55 78.75 -0.000933427 -0.0350331 0.000939583 -0.00100115 0.0350187 0.00100048 0.0 +1596 3.25 3.55 86.25 0.00219006 -0.0262185 -0.00219325 -0.00134055 0.0262088 0.0013392 0.0 +1597 3.25 3.55 93.75 0.00205156 -0.0171976 -0.00207372 -0.0011449 0.0171792 0.00114581 0.0 +1598 3.25 3.55 101.25 0.000259054 -0.00345069 -0.000235304 -0.00113486 0.00346766 0.00114093 0.0 +1599 3.25 3.55 108.75 0.00134517 0.0104896 -0.0013327 -0.00307345 -0.0104784 0.00307104 0.0 +1600 3.25 3.55 116.25 0.00233262 0.0144818 -0.00234223 -0.00230586 -0.0144733 0.00230359 0.0 +1601 3.25 3.55 123.75 0.00096001 0.00998525 -0.000959656 0.00167455 -0.00992985 -0.00169886 0.0 +1602 3.25 3.55 131.25 0.0010997 0.00500791 -0.00110082 0.00353768 -0.00496742 -0.00356791 0.0 +1603 3.25 3.55 138.75 0.00487751 0.00146684 -0.00487922 0.00142544 -0.00148711 -0.00141137 0.0 +1604 3.25 3.55 146.25 0.00734264 -0.00446313 -0.00734662 -0.000638225 0.00441882 0.000652058 0.0 +1605 3.25 3.55 153.75 0.00197693 -0.014869 -0.00196668 0.0013558 0.0148847 -0.00135051 0.0 +1606 3.25 3.55 161.25 -0.0121606 -0.0275418 0.0121409 0.00720885 0.027516 -0.00721154 0.0 +1607 3.25 3.55 168.75 -0.029033 -0.0382301 0.0290399 0.0137359 0.0382374 -0.01375 0.0 +1608 3.25 3.55 176.25 -0.0403659 -0.0441543 0.0403287 0.0177986 0.0441199 -0.0177946 0.0 +1609 3.25 3.65 3.75 29.8469 23.7536 -29.8469 114.399 -23.7536 -114.399 0.0 +1610 3.25 3.65 11.25 18.5821 12.1922 -18.5821 38.9798 -12.1922 -38.9798 0.0 +1611 3.25 3.65 18.75 7.82427 3.7514 -7.82427 9.32709 -3.7514 -9.32709 0.0 +1612 3.25 3.65 26.25 2.01633 0.610607 -2.01633 1.41075 -0.610606 -1.41076 0.0 +1613 3.25 3.65 33.75 0.207925 0.0661693 -0.207923 0.0650148 -0.0661712 -0.0650166 0.0 +1614 3.25 3.65 41.25 -0.0109411 0.0374143 0.0109448 -0.0172484 -0.0374174 0.0172482 0.0 +1615 3.25 3.65 48.75 0.00854362 0.00771035 -0.00854147 0.00574961 -0.00770984 -0.00574854 0.0 +1616 3.25 3.65 56.25 0.00259756 -0.00264422 -0.00260097 0.00942854 0.00264499 -0.00942948 0.0 +1617 3.25 3.65 63.75 -0.000120554 0.00078573 0.00012058 0.00313857 -0.000784598 -0.00313891 0.0 +1618 3.25 3.65 71.25 0.00248101 0.00185637 -0.00248337 0.000268246 -0.00186001 -0.000268224 0.0 +1619 3.25 3.65 78.75 0.00307847 0.00208771 -0.00307844 0.000606822 -0.00209071 -0.000606483 0.0 +1620 3.25 3.65 86.25 0.00187174 0.00124659 -0.00186937 0.00095551 -0.00124275 -0.000955129 0.0 +1621 3.25 3.65 93.75 6.19913e-05 -0.000371204 -6.04736e-05 0.000563209 0.000365014 -0.000562734 0.0 +1622 3.25 3.65 101.25 -0.000928172 -0.000436879 0.000926995 -0.00063032 0.000434748 0.000630276 0.0 +1623 3.25 3.65 108.75 -0.000830659 0.000473082 0.000832415 -0.00140972 -0.00047285 0.00140969 0.0 +1624 3.25 3.65 116.25 -0.000942827 0.000407146 0.00094397 -0.000633585 -0.000410022 0.000634706 0.0 +1625 3.25 3.65 123.75 -0.00166283 -0.000582597 0.001662 0.000718962 0.000586269 -0.000719648 0.0 +1626 3.25 3.65 131.25 -0.00204479 -0.00128755 0.00204388 0.000938967 0.00128792 -0.000939369 0.0 +1627 3.25 3.65 138.75 -0.00182542 -0.00123409 0.00182692 -0.000123482 0.00123642 0.000123147 0.0 +1628 3.25 3.65 146.25 -0.00225266 -0.000702446 0.00225351 -0.00119521 0.000700296 0.00119733 0.0 +1629 3.25 3.65 153.75 -0.00470753 0.000107114 0.0047067 -0.00120089 -0.000106024 0.00120018 0.0 +1630 3.25 3.65 161.25 -0.00916233 0.00120265 0.0091593 -0.000139049 -0.00120213 0.000137897 0.0 +1631 3.25 3.65 168.75 -0.0140233 0.0024012 0.0140238 0.00124784 -0.00240054 -0.00124848 0.0 +1632 3.25 3.65 176.25 -0.0171689 0.00321938 0.0171732 0.00216427 -0.00322149 -0.00216221 0.0 +1633 3.35 3.35 3.75 21.6477 545.28 -21.6477 11815.8 -545.28 -11815.8 0.0 +1634 3.35 3.35 11.25 0.173729 218.755 -0.173719 2394.74 -218.755 -2394.74 0.0 +1635 3.35 3.35 18.75 -9.53806 48.3705 9.53809 598.087 -48.3705 -598.087 0.0 +1636 3.35 3.35 26.25 -7.66274 -1.12322 7.66276 113.819 1.12321 -113.819 0.0 +1637 3.35 3.35 33.75 -2.74384 -3.33129 2.74384 12.9293 3.33125 -12.9293 0.0 +1638 3.35 3.35 41.25 -0.346706 -0.421196 0.346694 0.581284 0.421155 -0.581292 0.0 +1639 3.35 3.35 48.75 -0.0597258 -0.052617 0.0597015 0.0549515 0.0526707 -0.0549747 0.0 +1640 3.35 3.35 56.25 -0.126882 -0.137188 0.126857 0.0379118 0.137277 -0.0378934 0.0 +1641 3.35 3.35 63.75 -0.109892 -0.0878689 0.109868 0.00253737 0.0878685 -0.00255598 0.0 +1642 3.35 3.35 71.25 -0.0980488 -0.073463 0.0980418 -0.0105894 0.0734524 0.0105771 0.0 +1643 3.35 3.35 78.75 -0.0669262 -0.0528742 0.0669078 -0.0108983 0.0530139 0.0109302 0.0 +1644 3.35 3.35 86.25 -0.0219711 -0.0291652 0.0219318 -0.0154295 0.0291951 0.0154292 0.0 +1645 3.35 3.35 93.75 0.00146699 -0.0207303 -0.00146179 -0.0140867 0.020679 0.0140912 0.0 +1646 3.35 3.35 101.25 0.0168709 0.00290498 -0.0169225 -0.00898105 -0.00281588 0.00896964 0.0 +1647 3.35 3.35 108.75 0.0340663 0.0389815 -0.0340623 -0.0103442 -0.039102 0.0103711 0.0 +1648 3.35 3.35 116.25 0.0352042 0.0499497 -0.0351821 -0.0111656 -0.0499387 0.0111689 0.0 +1649 3.35 3.35 123.75 0.0178821 0.0273981 -0.0178368 -0.0038908 -0.0275323 0.00391568 0.0 +1650 3.35 3.35 131.25 0.00245117 -0.00157526 -0.00237029 0.00543782 0.0017713 -0.00545999 0.0 +1651 3.35 3.35 138.75 -0.000452681 -0.0169013 0.000469283 0.00962862 0.0169401 -0.00965926 0.0 +1652 3.35 3.35 146.25 -0.000710544 -0.0221597 0.000754182 0.0101186 0.0223253 -0.0102137 0.0 +1653 3.35 3.35 153.75 -0.0111111 -0.0323046 0.011189 0.0113797 0.0322223 -0.0112957 0.0 +1654 3.35 3.35 161.25 -0.0318368 -0.0542513 0.0318153 0.0143177 0.0540301 -0.014212 0.0 +1655 3.35 3.35 168.75 -0.0531774 -0.0809936 0.0531282 0.0170487 0.0810135 -0.0171249 0.0 +1656 3.35 3.35 176.25 -0.0660009 -0.0992697 0.0659877 0.01838 0.0992028 -0.0183637 0.0 +1657 3.35 3.45 3.75 264.52 547.577 -264.52 6202.93 -547.577 -6202.93 0.0 +1658 3.35 3.45 11.25 146.664 252.974 -146.664 1327.09 -252.974 -1327.09 0.0 +1659 3.35 3.45 18.75 55.5979 76.7316 -55.5979 320.33 -76.7316 -320.33 0.0 +1660 3.35 3.45 26.25 12.0322 12.2347 -12.0322 58.3259 -12.2346 -58.3259 0.0 +1661 3.35 3.45 33.75 0.596069 0.246217 -0.596031 6.50975 -0.246209 -6.50972 0.0 +1662 3.35 3.45 41.25 -0.174085 -0.0773709 0.174074 0.316004 0.0773448 -0.316022 0.0 +1663 3.35 3.45 48.75 -0.00445633 -0.0860244 0.00448977 0.0121395 0.0860192 -0.0120971 0.0 +1664 3.35 3.45 56.25 -0.0477545 -0.104883 0.0478083 0.0286837 0.104818 -0.0286912 0.0 +1665 3.35 3.45 63.75 -0.0332506 -0.0586084 0.0333016 0.00627557 0.0586119 -0.0062805 0.0 +1666 3.35 3.45 71.25 -0.0281034 -0.0608434 0.0280864 -0.00101144 0.0608456 0.00103223 0.0 +1667 3.35 3.45 78.75 -0.0318181 -0.0457338 0.0317996 0.00287139 0.0457793 -0.00287648 0.0 +1668 3.35 3.45 86.25 -0.0190638 -0.0189326 0.0190873 -0.00282309 0.0188606 0.00282802 0.0 +1669 3.35 3.45 93.75 -0.00845602 -0.00564765 0.00846357 -0.00258802 0.00569123 0.00258276 0.0 +1670 3.35 3.45 101.25 -0.000108637 0.0104483 0.000114753 0.00269483 -0.0103655 -0.00269193 0.0 +1671 3.35 3.45 108.75 0.0096153 0.0272037 -0.00961347 0.00262296 -0.0272254 -0.00260619 0.0 +1672 3.35 3.45 116.25 0.00852246 0.0258295 -0.00856241 0.0019054 -0.0259022 -0.00189501 0.0 +1673 3.35 3.45 123.75 -0.00485077 0.0100252 0.00491377 0.00479164 -0.010035 -0.00474465 0.0 +1674 3.35 3.45 131.25 -0.0151032 -0.00124015 0.0150869 0.00590864 0.00128885 -0.00595605 0.0 +1675 3.35 3.45 138.75 -0.0116773 0.000794051 0.0116531 0.00155451 -0.000693976 -0.00161011 0.0 +1676 3.35 3.45 146.25 0.000951708 0.00984726 -0.000976147 -0.00547841 -0.00985363 0.00546737 0.0 +1677 3.35 3.45 153.75 0.0141348 0.0178974 -0.0141348 -0.0120161 -0.0179225 0.0120171 0.0 +1678 3.35 3.45 161.25 0.024418 0.0223568 -0.0244107 -0.0180532 -0.022375 0.0180171 0.0 +1679 3.35 3.45 168.75 0.0321657 0.0245203 -0.0321044 -0.0239933 -0.0245871 0.0240198 0.0 +1680 3.35 3.45 176.25 0.0366433 0.0254514 -0.0366767 -0.0281044 -0.0255168 0.0281336 0.0 +1681 3.35 3.55 3.75 212.112 270.322 -212.112 1633.44 -270.322 -1633.44 0.0 +1682 3.35 3.55 11.25 122.019 134.508 -122.019 394.591 -134.508 -394.591 0.0 +1683 3.35 3.55 18.75 47.7974 44.519 -47.7974 89.0516 -44.519 -89.0516 0.0 +1684 3.35 3.55 26.25 11.0171 8.96418 -11.0171 14.3465 -8.96418 -14.3466 0.0 +1685 3.35 3.55 33.75 0.785538 1.00667 -0.785533 1.3707 -1.00666 -1.37071 0.0 +1686 3.35 3.55 41.25 -0.100275 0.111814 0.100273 0.063653 -0.111807 -0.0636804 0.0 +1687 3.35 3.55 48.75 0.0358723 -0.0504078 -0.0358729 0.0207167 0.0504272 -0.0207188 0.0 +1688 3.35 3.55 56.25 -0.0107991 -0.0545945 0.0108077 0.0260469 0.0545759 -0.0260665 0.0 +1689 3.35 3.55 63.75 -0.0137965 -0.0162173 0.01382 0.00310984 0.0162029 -0.00312469 0.0 +1690 3.35 3.55 71.25 -0.00443791 -0.0176794 0.00444316 -0.0030039 0.0176744 0.00300773 0.0 +1691 3.35 3.55 78.75 -0.00661178 -0.0194646 0.00662503 -0.000183672 0.0194799 0.000190292 0.0 +1692 3.35 3.55 86.25 -0.0044624 -0.0145146 0.00445811 -0.00308715 0.0145483 0.00308949 0.0 +1693 3.35 3.55 93.75 -0.00201713 -0.0103082 0.00203467 -0.0034837 0.0103487 0.00348302 0.0 +1694 3.35 3.55 101.25 0.000612684 -0.00214047 -0.000633647 -0.00170294 0.00208873 0.00170816 0.0 +1695 3.35 3.55 108.75 0.00492679 0.00544074 -0.00492725 -0.000964504 -0.00547196 0.000980009 0.0 +1696 3.35 3.55 116.25 0.00552459 0.00494329 -0.00551079 0.00128236 -0.00490754 -0.00128794 0.0 +1697 3.35 3.55 123.75 0.00248381 -0.000309276 -0.00248587 0.00443651 0.000330766 -0.00443577 0.0 +1698 3.35 3.55 131.25 0.00307595 -0.00427668 -0.00308807 0.00457978 0.00431048 -0.00460838 0.0 +1699 3.35 3.55 138.75 0.0100829 -0.00649667 -0.0100649 0.00162916 0.00646752 -0.00160639 0.0 +1700 3.35 3.55 146.25 0.0183636 -0.0087324 -0.0183591 -0.00101933 0.00878923 0.000998688 0.0 +1701 3.35 3.55 153.75 0.0223417 -0.00978813 -0.0223341 -0.00163428 0.00977234 0.00164318 0.0 +1702 3.35 3.55 161.25 0.0213234 -0.00730229 -0.0213443 -0.0014192 0.00724781 0.00144804 0.0 +1703 3.35 3.55 168.75 0.0183265 -0.00180711 -0.0183314 -0.00178155 0.00182466 0.00177075 0.0 +1704 3.35 3.55 176.25 0.0161793 0.00277081 -0.0161889 -0.00245834 -0.00278613 0.00245868 0.0 +1705 3.35 3.65 3.75 34.2993 31.2111 -34.2993 99.1827 -31.2111 -99.1827 0.0 +1706 3.35 3.65 11.25 20.1073 16.1249 -20.1073 25.0862 -16.1249 -25.0862 0.0 +1707 3.35 3.65 18.75 7.81038 5.38483 -7.81038 4.29487 -5.38483 -4.29487 0.0 +1708 3.35 3.65 26.25 1.72232 1.10266 -1.72232 0.220387 -1.10265 -0.220388 0.0 +1709 3.35 3.65 33.75 0.0886792 0.151586 -0.0886799 -0.0820027 -0.151586 0.0820019 0.0 +1710 3.35 3.65 41.25 -0.0173171 0.0309048 0.0173154 -0.015518 -0.0309058 0.0155196 0.0 +1711 3.35 3.65 48.75 0.0101661 -0.00286499 -0.0101673 0.00763683 0.00286567 -0.00763753 0.0 +1712 3.35 3.65 56.25 -0.002689 -0.00624694 0.00268935 0.0083081 0.00624704 -0.00830852 0.0 +1713 3.35 3.65 63.75 -0.00312949 0.000414859 0.00313187 0.00248767 -0.000415121 -0.00248719 0.0 +1714 3.35 3.65 71.25 0.00176759 0.00183364 -0.00176593 0.000912355 -0.00183059 -0.000912314 0.0 +1715 3.35 3.65 78.75 0.00272836 0.00157348 -0.00272759 0.00117466 -0.00157332 -0.00117415 0.0 +1716 3.35 3.65 86.25 0.00159309 0.000928734 -0.00159386 0.000236076 -0.000929755 -0.000236263 0.0 +1717 3.35 3.65 93.75 -8.27674e-05 0.000144333 8.23358e-05 -0.00112934 -0.000145183 0.00112914 0.0 +1718 3.35 3.65 101.25 -0.000947847 0.000224482 0.00094892 -0.00225916 -0.000225888 0.00225973 0.0 +1719 3.35 3.65 108.75 -0.000863792 0.000432852 0.000864512 -0.00237019 -0.000431765 0.0023699 0.0 +1720 3.35 3.65 116.25 -0.000961541 -5.64864e-05 0.000960868 -0.0011264 6.07289e-05 0.00112608 0.0 +1721 3.35 3.65 123.75 -0.00127243 -0.000805706 0.0012707 0.000252729 0.000806025 -0.000253886 0.0 +1722 3.35 3.65 131.25 -0.000913381 -0.00130653 0.000910966 0.000474326 0.00130583 -0.000474541 0.0 +1723 3.35 3.65 138.75 -5.53154e-05 -0.00154588 5.78325e-05 -0.000286174 0.00155054 0.000285032 0.0 +1724 3.35 3.65 146.25 -6.51777e-05 -0.00124019 6.5744e-05 -0.000995048 0.00124163 0.000994467 0.0 +1725 3.35 3.65 153.75 -0.0019038 0.00032226 0.00190333 -0.00107275 -0.000320901 0.00107123 0.0 +1726 3.35 3.65 161.25 -0.00517932 0.00335224 0.00517862 -0.000703318 -0.00335729 0.000705883 0.0 +1727 3.35 3.65 168.75 -0.00853589 0.00691614 0.00853695 -0.000307448 -0.00691271 0.000304936 0.0 +1728 3.35 3.65 176.25 -0.0106065 0.00934073 0.0106054 -0.000100664 -0.0093421 0.000101267 0.0 +1729 3.45 3.45 3.75 249.963 447.743 -249.963 3664.97 -447.743 -3664.97 0.0 +1730 3.45 3.45 11.25 130.312 207.993 -130.312 676.249 -207.993 -676.249 0.0 +1731 3.45 3.45 18.75 45.7667 65.0303 -45.7667 147.519 -65.0303 -147.519 0.0 +1732 3.45 3.45 26.25 8.62768 11.3441 -8.62769 23.4633 -11.3441 -23.4633 0.0 +1733 3.45 3.45 33.75 0.110016 0.590793 -0.109988 2.30758 -0.590787 -2.3076 0.0 +1734 3.45 3.45 41.25 -0.153757 -0.0039627 0.153717 0.133259 0.00394772 -0.133226 0.0 +1735 3.45 3.45 48.75 -0.0153495 -0.0393026 0.0153515 0.00700061 0.0393356 -0.00698054 0.0 +1736 3.45 3.45 56.25 -0.0482726 -0.073912 0.0483149 0.0251197 0.0739223 -0.0251188 0.0 +1737 3.45 3.45 63.75 -0.0289355 -0.0533479 0.0289021 0.00597862 0.053373 -0.00597884 0.0 +1738 3.45 3.45 71.25 -0.0187811 -0.0391984 0.018746 0.000512192 0.039198 -0.000501842 0.0 +1739 3.45 3.45 78.75 -0.00856621 -0.0176478 0.00859924 0.00690296 0.0177056 -0.00690308 0.0 +1740 3.45 3.45 86.25 0.00371125 -0.0135792 -0.00372377 0.00136037 0.0136089 -0.0013601 0.0 +1741 3.45 3.45 93.75 0.00477561 -0.0238325 -0.00478562 -0.00283706 0.0238591 0.00283968 0.0 +1742 3.45 3.45 101.25 0.00818656 -0.0174538 -0.00812902 -0.00263731 0.017444 0.00264151 0.0 +1743 3.45 3.45 108.75 0.0169419 0.00155597 -0.0169639 -0.00543721 -0.00155808 0.00543126 0.0 +1744 3.45 3.45 116.25 0.0195788 0.0116859 -0.0195369 -0.00999959 -0.0117365 0.0100136 0.0 +1745 3.45 3.45 123.75 0.0183927 0.0116238 -0.0183971 -0.013227 -0.011666 0.0132448 0.0 +1746 3.45 3.45 131.25 0.0233808 0.0121941 -0.0234038 -0.0149326 -0.0122148 0.0149266 0.0 +1747 3.45 3.45 138.75 0.0316355 0.0161105 -0.0316222 -0.0142598 -0.0161126 0.0142499 0.0 +1748 3.45 3.45 146.25 0.0319972 0.0182352 -0.0319926 -0.0107349 -0.018201 0.0107262 0.0 +1749 3.45 3.45 153.75 0.0212885 0.0151617 -0.0213003 -0.0072284 -0.0151286 0.00721379 0.0 +1750 3.45 3.45 161.25 0.00710262 0.00875975 -0.00709702 -0.00763624 -0.00879653 0.00766868 0.0 +1751 3.45 3.45 168.75 -0.0026401 0.00265877 0.00265377 -0.0121265 -0.00270055 0.0121613 0.0 +1752 3.45 3.45 176.25 -0.00643116 -0.000726218 0.00644015 -0.0165154 0.000842039 0.0164549 0.0 +1753 3.45 3.55 3.75 176.165 231.846 -176.165 1002.13 -231.846 -1002.13 0.0 +1754 3.45 3.55 11.25 95.7124 114.358 -95.7124 175.442 -114.358 -175.442 0.0 +1755 3.45 3.55 18.75 35.3486 38.8706 -35.3486 30.2113 -38.8706 -30.2113 0.0 +1756 3.45 3.55 26.25 7.45817 8.24142 -7.45818 2.93187 -8.24142 -2.93187 0.0 +1757 3.45 3.55 33.75 0.442038 0.937077 -0.442023 0.16053 -0.937083 -0.160524 0.0 +1758 3.45 3.55 41.25 -0.036135 0.0544695 0.0361478 0.0475514 -0.0544678 -0.0475693 0.0 +1759 3.45 3.55 48.75 0.0114763 -0.0262494 -0.0114589 0.0137087 0.0262505 -0.0137065 0.0 +1760 3.45 3.55 56.25 -0.0247279 -0.0151853 0.0247269 0.0138833 0.0151975 -0.0138936 0.0 +1761 3.45 3.55 63.75 -0.00534614 0.000359977 0.00535626 -0.000883675 -0.000355567 0.000884282 0.0 +1762 3.45 3.55 71.25 0.0021508 -0.00431124 -0.00217205 -0.00167595 0.00430117 0.00167024 0.0 +1763 3.45 3.55 78.75 -0.00618242 -0.0011063 0.00617677 0.00219776 0.00111944 -0.00219769 0.0 +1764 3.45 3.55 86.25 -0.00864154 0.00382556 0.00863024 -0.000880014 -0.00382877 0.000881011 0.0 +1765 3.45 3.55 93.75 -0.00688417 0.00308196 0.00688064 -0.000591138 -0.00307945 0.000591269 0.0 +1766 3.45 3.55 101.25 -0.00277733 0.00250811 0.00278446 0.00339576 -0.00248041 -0.00339897 0.0 +1767 3.45 3.55 108.75 9.6645e-05 0.00292517 -9.27955e-05 0.00533124 -0.00297869 -0.00532125 0.0 +1768 3.45 3.55 116.25 -0.00279109 0.00312423 0.0027777 0.004826 -0.00313043 -0.00482587 0.0 +1769 3.45 3.55 123.75 -0.007852 0.00420337 0.00785189 0.00337755 -0.00423422 -0.00336561 0.0 +1770 3.45 3.55 131.25 -0.00899665 0.00525366 0.00898163 0.00211415 -0.00526556 -0.00211688 0.0 +1771 3.45 3.55 138.75 -0.00658818 0.00353401 0.00658935 0.00247574 -0.00351467 -0.00247806 0.0 +1772 3.45 3.55 146.25 -0.00472251 -0.000274464 0.0047137 0.00454554 0.000265355 -0.00453667 0.0 +1773 3.45 3.55 153.75 -0.00408631 -0.00145214 0.00408205 0.00601461 0.00145164 -0.0060113 0.0 +1774 3.45 3.55 161.25 -0.00213812 0.00336809 0.00214451 0.0045329 -0.00336917 -0.00453833 0.0 +1775 3.45 3.55 168.75 0.002039 0.0122448 -0.00204369 0.000537346 -0.0122471 -0.000536574 0.0 +1776 3.45 3.55 176.25 0.00576826 0.0191805 -0.00579318 -0.00289312 -0.0192316 0.00291892 0.0 +1777 3.45 3.65 3.75 27.0106 27.9613 -27.0106 49.4083 -27.9613 -49.4083 0.0 +1778 3.45 3.65 11.25 14.9394 14.3629 -14.9394 5.91574 -14.3629 -5.91574 0.0 +1779 3.45 3.65 18.75 5.42704 4.99328 -5.42704 -0.785154 -4.99328 0.785155 0.0 +1780 3.45 3.65 26.25 1.05899 1.10476 -1.05899 -0.658621 -1.10476 0.658622 0.0 +1781 3.45 3.65 33.75 0.0281818 0.145917 -0.0281832 -0.129014 -0.145916 0.129014 0.0 +1782 3.45 3.65 41.25 -0.00445013 0.00847625 0.00444947 -0.00108348 -0.0084749 0.00108322 0.0 +1783 3.45 3.65 48.75 0.00425589 -0.0101956 -0.00425551 0.00738506 0.0101965 -0.00738428 0.0 +1784 3.45 3.65 56.25 -0.00818272 -0.00590468 0.00818308 0.00485965 0.00590354 -0.00486006 0.0 +1785 3.45 3.65 63.75 -0.00416452 -0.000816284 0.00416288 0.00103036 0.000813653 -0.00103209 0.0 +1786 3.45 3.65 71.25 0.00103127 -0.00146141 -0.00103277 0.000818187 0.00146199 -0.000819189 0.0 +1787 3.45 3.65 78.75 0.0016058 -0.00187691 -0.00160474 0.000733485 0.00187607 -0.000733211 0.0 +1788 3.45 3.65 86.25 0.00109362 -0.000919641 -0.00109306 -0.000877938 0.000920276 0.000877779 0.0 +1789 3.45 3.65 93.75 0.000615382 -0.000162543 -0.000614614 -0.00196718 0.000162038 0.00196727 0.0 +1790 3.45 3.65 101.25 0.000257077 -9.90887e-05 -0.000257803 -0.00198713 9.8806e-05 0.00198727 0.0 +1791 3.45 3.65 108.75 -0.000415666 -0.000551723 0.000416382 -0.00133258 0.000550085 0.00133277 0.0 +1792 3.45 3.65 116.25 -0.00171058 -0.00100344 0.00171033 -0.000283121 0.00100575 0.000281567 0.0 +1793 3.45 3.65 123.75 -0.00282345 -0.00136999 0.00282231 0.000681739 0.00136679 -0.000680174 0.0 +1794 3.45 3.65 131.25 -0.00293906 -0.00227991 0.00293814 0.00125143 0.00227664 -0.00125029 0.0 +1795 3.45 3.65 138.75 -0.00235433 -0.00392254 0.0023561 0.0016008 0.00392512 -0.00160107 0.0 +1796 3.45 3.65 146.25 -0.00181787 -0.00523799 0.00181858 0.00193355 0.00523773 -0.00193291 0.0 +1797 3.45 3.65 153.75 -0.00147655 -0.00473654 0.00147561 0.00211445 0.00473647 -0.00211477 0.0 +1798 3.45 3.65 161.25 -0.000967812 -0.00201348 0.000967111 0.00191586 0.00201087 -0.00191381 0.0 +1799 3.45 3.65 168.75 -0.000185572 0.00169462 0.000184459 0.00140918 -0.00169418 -0.00140983 0.0 +1800 3.45 3.65 176.25 0.000452234 0.00431542 -0.000452919 0.000978651 -0.00431348 -0.000979895 0.0 +1801 3.55 3.55 3.75 81.0059 113.34 -81.0059 260.352 -113.34 -260.352 0.0 +1802 3.55 3.55 11.25 42.1524 56.4121 -42.1524 26.3617 -56.4121 -26.3617 0.0 +1803 3.55 3.55 18.75 14.7132 19.7973 -14.7132 -0.755035 -19.7973 0.755033 0.0 +1804 3.55 3.55 26.25 2.79612 4.5306 -2.79613 -1.38915 -4.53059 1.38915 0.0 +1805 3.55 3.55 33.75 0.10053 0.64794 -0.100533 -0.160016 -0.647941 0.160018 0.0 +1806 3.55 3.55 41.25 -0.0178303 0.07505 0.0178293 0.0195223 -0.0750523 -0.0195244 0.0 +1807 3.55 3.55 48.75 -0.00517875 -0.00351167 0.00518041 0.00760166 0.00350383 -0.00760536 0.0 +1808 3.55 3.55 56.25 -0.0146237 -0.0107977 0.0146179 0.0109189 0.0107984 -0.0109269 0.0 +1809 3.55 3.55 63.75 -3.87507e-05 -0.00362228 4.15324e-05 -0.000860953 0.0036153 0.000862609 0.0 +1810 3.55 3.55 71.25 0.00025554 0.00310581 -0.000258051 -0.00193062 -0.00311301 0.00192984 0.0 +1811 3.55 3.55 78.75 -0.00939829 0.0115235 0.0094016 0.000961058 -0.0115276 -0.000962838 0.0 +1812 3.55 3.55 86.25 -0.0165596 0.0133942 0.0165552 -0.000618444 -0.0133937 0.000618414 0.0 +1813 3.55 3.55 93.75 -0.0192198 0.0081303 0.0192237 0.000800086 -0.00813014 -0.000800389 0.0 +1814 3.55 3.55 101.25 -0.0173135 0.00397392 0.017316 0.00498683 -0.0039722 -0.00498686 0.0 +1815 3.55 3.55 108.75 -0.0127763 0.00613703 0.0127729 0.00547732 -0.00614031 -0.00547708 0.0 +1816 3.55 3.55 116.25 -0.00660985 0.0146966 0.00660871 0.000809944 -0.0146938 -0.000810497 0.0 +1817 3.55 3.55 123.75 0.00134833 0.025362 -0.00135008 -0.00514917 -0.0253577 0.0051477 0.0 +1818 3.55 3.55 131.25 0.00729171 0.0312649 -0.00729682 -0.00779015 -0.0312805 0.00779548 0.0 +1819 3.55 3.55 138.75 0.00442273 0.0279187 -0.00442424 -0.00517592 -0.0279147 0.00517078 0.0 +1820 3.55 3.55 146.25 -0.0095565 0.0168767 0.00955964 0.000965394 -0.0168727 -0.000968108 0.0 +1821 3.55 3.55 153.75 -0.0293138 0.00381127 0.0293123 0.00695552 -0.00382228 -0.00695117 0.0 +1822 3.55 3.55 161.25 -0.0467198 -0.00619086 0.0467172 0.0101031 0.00618452 -0.0101001 0.0 +1823 3.55 3.55 168.75 -0.0572524 -0.0115126 0.0572543 0.0103575 0.0115196 -0.0103592 0.0 +1824 3.55 3.55 176.25 -0.0614583 -0.0133864 0.0614549 0.00960442 0.0133863 -0.00960501 0.0 +1825 3.55 3.65 3.75 12.0786 14.33 -12.0786 4.38613 -14.33 -4.38613 0.0 +1826 3.55 3.65 11.25 6.33912 7.33576 -6.33912 -3.18423 -7.33576 3.18423 0.0 +1827 3.55 3.65 18.75 2.17784 2.6298 -2.17784 -1.96003 -2.6298 1.96003 0.0 +1828 3.55 3.65 26.25 0.39006 0.617253 -0.390059 -0.575786 -0.617253 0.575786 0.0 +1829 3.55 3.65 33.75 0.012681 0.0862211 -0.0126807 -0.0681723 -0.0862212 0.0681722 0.0 +1830 3.55 3.65 41.25 0.00502234 0.00223156 -0.00502212 0.00459513 -0.00223169 -0.00459442 0.0 +1831 3.55 3.65 48.75 0.00119944 -0.00628422 -0.00119894 0.00406756 0.00628446 -0.004068 0.0 +1832 3.55 3.65 56.25 -0.00386742 -0.003943 0.0038666 0.00178896 0.00394351 -0.00178918 0.0 +1833 3.55 3.65 63.75 -8.12468e-05 -0.00348925 8.0267e-05 -0.000674629 0.00348964 0.000674362 0.0 +1834 3.55 3.65 71.25 0.00192557 -0.00505585 -0.00192533 -0.00075298 0.00505521 0.00075297 0.0 +1835 3.55 3.65 78.75 0.00130323 -0.00454114 -0.0013032 -0.000636843 0.00454084 0.000636893 0.0 +1836 3.55 3.65 86.25 0.000803867 -0.00245655 -0.00080399 -0.00102105 0.0024577 0.00102106 0.0 +1837 3.55 3.65 93.75 0.0005973 -0.00111275 -0.000596389 -0.00057336 0.00111433 0.000573242 0.0 +1838 3.55 3.65 101.25 8.21929e-06 -0.00103481 -8.12152e-06 0.000450279 0.00103466 -0.00045023 0.0 +1839 3.55 3.65 108.75 -0.00119309 -0.00126494 0.00119399 0.0010993 0.00126523 -0.00109935 0.0 +1840 3.55 3.65 116.25 -0.00250233 -0.00111306 0.0025023 0.00122707 0.00111394 -0.00122737 0.0 +1841 3.55 3.65 123.75 -0.00325961 -0.00112678 0.00325939 0.00125572 0.00112681 -0.00125599 0.0 +1842 3.55 3.65 131.25 -0.0035151 -0.00233904 0.00351542 0.00158179 0.00233879 -0.00158147 0.0 +1843 3.55 3.65 138.75 -0.00380524 -0.00487295 0.00380513 0.00228977 0.0048732 -0.00229011 0.0 +1844 3.55 3.65 146.25 -0.00421555 -0.00763611 0.00421483 0.00312216 0.00763468 -0.00312155 0.0 +1845 3.55 3.65 153.75 -0.0041875 -0.00929866 0.0041879 0.00369562 0.00929919 -0.00369561 0.0 +1846 3.55 3.65 161.25 -0.00326306 -0.00936525 0.00326349 0.00381045 0.00936578 -0.00381069 0.0 +1847 3.55 3.65 168.75 -0.00175148 -0.00841033 0.00175132 0.00358917 0.00841037 -0.00358917 0.0 +1848 3.55 3.65 176.25 -0.000592392 -0.007527 0.000592354 0.00335056 0.00752733 -0.00335069 0.0 +1849 3.65 3.65 3.75 1.34179 1.8764 -1.34179 -2.21207 -1.8764 2.21207 0.0 +1850 3.65 3.65 11.25 0.674722 0.975627 -0.674722 -1.01114 -0.975627 1.01114 0.0 +1851 3.65 3.65 18.75 0.218094 0.365855 -0.218094 -0.384938 -0.365855 0.384938 0.0 +1852 3.65 3.65 26.25 0.034533 0.0959486 -0.034533 -0.0883541 -0.0959486 0.0883541 0.0 +1853 3.65 3.65 33.75 0.000906004 0.0183831 -0.000905993 -0.00778172 -0.0183832 0.00778172 0.0 +1854 3.65 3.65 41.25 0.00132048 0.00271731 -0.00132051 0.00071098 -0.00271729 -0.000710997 0.0 +1855 3.65 3.65 48.75 0.000821636 -0.000306112 -0.00082155 0.000743727 0.000306079 -0.000743719 0.0 +1856 3.65 3.65 56.25 0.00055949 -0.000894959 -0.000559485 0.000325653 0.000894939 -0.000325638 0.0 +1857 3.65 3.65 63.75 0.000919031 -0.00134167 -0.000918928 -0.000425567 0.0013417 0.000425618 0.0 +1858 3.65 3.65 71.25 0.00068388 -0.00161126 -0.000683975 -0.000595268 0.00161117 0.000595242 0.0 +1859 3.65 3.65 78.75 0.000214632 -0.00126472 -0.000214751 -0.000489084 0.00126474 0.000489099 0.0 +1860 3.65 3.65 86.25 8.67817e-06 -0.000701107 -8.75836e-06 -0.000274181 0.00070111 0.000274184 0.0 +1861 3.65 3.65 93.75 1.71384e-06 -0.000443281 -1.76788e-06 0.000154524 0.000443329 -0.000154528 0.0 +1862 3.65 3.65 101.25 1.95029e-05 -0.000477718 -1.95794e-05 0.000567489 0.000477841 -0.000567493 0.0 +1863 3.65 3.65 108.75 7.48783e-05 -0.00049436 -7.48748e-05 0.000683729 0.000494453 -0.000683746 0.0 +1864 3.65 3.65 116.25 0.000265232 -0.000391767 -0.000265328 0.00052426 0.000391822 -0.000524261 0.0 +1865 3.65 3.65 123.75 0.000509939 -0.000400182 -0.000509922 0.000310119 0.000400276 -0.000310147 0.0 +1866 3.65 3.65 131.25 0.000525607 -0.000787876 -0.000525615 0.000228989 0.000787858 -0.00022897 0.0 +1867 3.65 3.65 138.75 0.000108536 -0.00156718 -0.000108471 0.000330074 0.00156723 -0.000330079 0.0 +1868 3.65 3.65 146.25 -0.000640149 -0.00249673 0.000640125 0.000548861 0.00249673 -0.000548895 0.0 +1869 3.65 3.65 153.75 -0.0014021 -0.00329158 0.00140212 0.000784814 0.00329161 -0.000784826 0.0 +1870 3.65 3.65 161.25 -0.00190979 -0.00380299 0.00190977 0.000966445 0.00380303 -0.000966483 0.0 +1871 3.65 3.65 168.75 -0.00211603 -0.00404799 0.00211605 0.00107292 0.004048 -0.00107292 0.0 +1872 3.65 3.65 176.25 -0.00215132 -0.00412886 0.00215137 0.00111754 0.00412895 -0.00111757 0.0 diff --git a/unittest/force-styles/tests/1-1-2.table b/unittest/force-styles/tests/1-1-2.table new file mode 100644 index 0000000000..528627f03a --- /dev/null +++ b/unittest/force-styles/tests/1-1-2.table @@ -0,0 +1,3459 @@ +ENTRY1 +N 12 rmin 2.55 rmax 3.65 + +1 2.55 2.55 3.75 -867.212 -611.273 867.212 21386.8 611.273 -21386.8 0.0 +2 2.55 2.55 11.25 -621.539 -411.189 621.539 5035.95 411.189 -5035.95 0.0 +3 2.55 2.55 18.75 -394.167 -243.287 394.167 1722.21 243.287 -1722.21 0.0 +4 2.55 2.55 26.25 -218.789 -127.402 218.789 560.206 127.402 -560.206 0.0 +5 2.55 2.55 33.75 -104.252 -59.5774 104.252 156.639 59.5774 -156.639 0.0 +6 2.55 2.55 41.25 -41.0722 -24.6716 41.072 36.4446 24.6716 -36.4446 0.0 +7 2.55 2.55 48.75 -12.357 -8.38061 12.3571 7.1117 8.38062 -7.1117 0.0 +8 2.55 2.55 56.25 -2.29912 -1.68047 2.29907 0.91657 1.68048 -0.916568 0.0 +9 2.55 2.55 63.75 -0.0509977 0.327321 0.0509129 -0.304729 -0.327319 0.30474 0.0 +10 2.55 2.55 71.25 0.0345509 0.431792 -0.0345867 -0.382614 -0.431782 0.382616 0.0 +11 2.55 2.55 78.75 -0.00019898 0.179593 0.000319523 -0.292658 -0.179608 0.292661 0.0 +12 2.55 2.55 86.25 0.154169 0.138217 -0.154088 -0.302917 -0.138224 0.302914 0.0 +13 2.55 2.55 93.75 0.327691 0.263922 -0.327675 -0.340147 -0.263894 0.340148 0.0 +14 2.55 2.55 101.25 0.382895 0.350591 -0.382883 -0.297308 -0.350546 0.297312 0.0 +15 2.55 2.55 108.75 0.300955 0.297417 -0.300746 -0.173862 -0.297437 0.173872 0.0 +16 2.55 2.55 116.25 0.138507 0.141879 -0.138328 -0.0349372 -0.1418 0.0349415 0.0 +17 2.55 2.55 123.75 -0.0287949 -0.0286834 0.0286744 0.065848 0.0287665 -0.0658601 0.0 +18 2.55 2.55 131.25 -0.160323 -0.164235 0.160302 0.120341 0.164191 -0.120297 0.0 +19 2.55 2.55 138.75 -0.274013 -0.280673 0.274077 0.156939 0.280642 -0.156913 0.0 +20 2.55 2.55 146.25 -0.42361 -0.430992 0.423711 0.212433 0.430824 -0.212358 0.0 +21 2.55 2.55 153.75 -0.648177 -0.651719 0.648516 0.305821 0.651726 -0.305791 0.0 +22 2.55 2.55 161.25 -0.93181 -0.926724 0.931895 0.426805 0.926702 -0.426778 0.0 +23 2.55 2.55 168.75 -1.20276 -1.18735 1.20273 0.541966 1.18745 -0.542019 0.0 +24 2.55 2.55 176.25 -1.36933 -1.34705 1.3691 0.612284 1.34703 -0.612297 0.0 +25 2.55 2.65 3.75 -784.444 -675.519 784.444 19696.9 675.519 -19696.9 0.0 +26 2.55 2.65 11.25 -542.941 -440.852 542.941 5300.59 440.852 -5300.59 0.0 +27 2.55 2.65 18.75 -325.839 -241.234 325.839 1817.37 241.234 -1817.37 0.0 +28 2.55 2.65 26.25 -169.421 -111.015 169.421 580.214 111.015 -580.214 0.0 +29 2.55 2.65 33.75 -74.994 -43.3669 74.994 155.496 43.3669 -155.496 0.0 +30 2.55 2.65 41.25 -27.0736 -14.8824 27.0736 33.1152 14.8824 -33.1152 0.0 +31 2.55 2.65 48.75 -7.12613 -4.62454 7.12621 5.36809 4.62453 -5.36811 0.0 +32 2.55 2.65 56.25 -0.874199 -1.13723 0.874234 0.34195 1.13723 -0.341919 0.0 +33 2.55 2.65 63.75 0.204812 -0.0406907 -0.204883 -0.442652 0.0407084 0.442642 0.0 +34 2.55 2.65 71.25 0.0904568 0.154881 -0.0905494 -0.435451 -0.154894 0.435459 0.0 +35 2.55 2.65 78.75 0.0458835 0.126591 -0.0460614 -0.333955 -0.126573 0.33396 0.0 +36 2.55 2.65 86.25 0.168148 0.163197 -0.168343 -0.309845 -0.163197 0.309848 0.0 +37 2.55 2.65 93.75 0.296449 0.261093 -0.296361 -0.307947 -0.261084 0.307954 0.0 +38 2.55 2.65 101.25 0.329963 0.311331 -0.329831 -0.254571 -0.311318 0.254565 0.0 +39 2.55 2.65 108.75 0.253841 0.255391 -0.253789 -0.146686 -0.255437 0.146721 0.0 +40 2.55 2.65 116.25 0.107857 0.119105 -0.107492 -0.0254819 -0.119136 0.0254837 0.0 +41 2.55 2.65 123.75 -0.0492191 -0.0344023 0.0490594 0.0707149 0.0343792 -0.0707119 0.0 +42 2.55 2.65 131.25 -0.180513 -0.166858 0.180388 0.1322 0.16692 -0.132248 0.0 +43 2.55 2.65 138.75 -0.300448 -0.291041 0.300451 0.178321 0.291015 -0.178345 0.0 +44 2.55 2.65 146.25 -0.45666 -0.451363 0.456715 0.239144 0.451427 -0.239145 0.0 +45 2.55 2.65 153.75 -0.684349 -0.67857 0.684481 0.332093 0.678651 -0.332112 0.0 +46 2.55 2.65 161.25 -0.966732 -0.954719 0.966651 0.448833 0.954615 -0.448783 0.0 +47 2.55 2.65 168.75 -1.23353 -1.21297 1.23383 0.558954 1.21297 -0.558949 0.0 +48 2.55 2.65 176.25 -1.39695 -1.37031 1.39698 0.626037 1.37022 -0.625967 0.0 +49 2.55 2.75 3.75 -668.413 -701.057 668.413 15096.3 701.057 -15096.3 0.0 +50 2.55 2.75 11.25 -452.8 -464.411 452.8 5130.32 464.411 -5130.32 0.0 +51 2.55 2.75 18.75 -256.012 -246.87 256.012 1797.07 246.87 -1797.07 0.0 +52 2.55 2.75 26.25 -123.333 -105.643 123.333 565.052 105.643 -565.052 0.0 +53 2.55 2.75 33.75 -50.2709 -35.7913 50.2709 144.93 35.7913 -144.93 0.0 +54 2.55 2.75 41.25 -16.78 -9.69921 16.78 28.1038 9.69923 -28.1038 0.0 +55 2.55 2.75 48.75 -4.12155 -2.37411 4.12164 3.76214 2.3741 -3.76217 0.0 +56 2.55 2.75 56.25 -0.484016 -0.658362 0.484128 0.146857 0.658338 -0.146846 0.0 +57 2.55 2.75 63.75 0.0687647 -0.20106 -0.0687734 -0.260534 0.20103 0.260497 0.0 +58 2.55 2.75 71.25 -0.00147066 -0.0603687 0.0015277 -0.268714 0.0604159 0.268722 0.0 +59 2.55 2.75 78.75 0.0156999 0.0125791 -0.0159656 -0.252993 -0.0125614 0.252974 0.0 +60 2.55 2.75 86.25 0.136925 0.119249 -0.13684 -0.269725 -0.11924 0.269725 0.0 +61 2.55 2.75 93.75 0.247327 0.234358 -0.247334 -0.272826 -0.234332 0.272827 0.0 +62 2.55 2.75 101.25 0.281753 0.286511 -0.281826 -0.224691 -0.286549 0.224691 0.0 +63 2.55 2.75 108.75 0.226138 0.242659 -0.226349 -0.131815 -0.24272 0.131841 0.0 +64 2.55 2.75 116.25 0.106433 0.12752 -0.10664 -0.0258695 -0.127594 0.0258609 0.0 +65 2.55 2.75 123.75 -0.0277616 -0.00630627 0.0276778 0.0615222 0.00630865 -0.0614969 0.0 +66 2.55 2.75 131.25 -0.142446 -0.124893 0.142414 0.118979 0.124975 -0.11903 0.0 +67 2.55 2.75 138.75 -0.248783 -0.237903 0.248779 0.161562 0.237995 -0.161575 0.0 +68 2.55 2.75 146.25 -0.392668 -0.385233 0.392627 0.216964 0.385134 -0.21689 0.0 +69 2.55 2.75 153.75 -0.606858 -0.595071 0.606818 0.302592 0.595088 -0.302606 0.0 +70 2.55 2.75 161.25 -0.874793 -0.851019 0.874799 0.411383 0.850969 -0.411357 0.0 +71 2.55 2.75 168.75 -1.12893 -1.0911 1.12904 0.514712 1.09102 -0.514675 0.0 +72 2.55 2.75 176.25 -1.28457 -1.23755 1.28455 0.577854 1.23747 -0.577828 0.0 +73 2.55 2.85 3.75 -540.757 -671.949 540.757 11232.9 671.949 -11232.9 0.0 +74 2.55 2.85 11.25 -358.962 -456.955 358.962 4626.32 456.955 -4626.32 0.0 +75 2.55 2.85 18.75 -189.205 -242.387 189.205 1670.73 242.387 -1670.73 0.0 +76 2.55 2.85 26.25 -82.3789 -101.034 82.3789 518.217 101.034 -518.217 0.0 +77 2.55 2.85 33.75 -30.0098 -32.1026 30.0098 126.998 32.1025 -126.998 0.0 +78 2.55 2.85 41.25 -9.21751 -7.56922 9.21749 22.2838 7.5692 -22.2838 0.0 +79 2.55 2.85 48.75 -2.28489 -1.50529 2.28485 2.35574 1.50529 -2.35573 0.0 +80 2.55 2.85 56.25 -0.358049 -0.489852 0.357948 0.0188984 0.489874 -0.0189109 0.0 +81 2.55 2.85 63.75 -0.00522043 -0.307792 0.00494878 -0.134592 0.307776 0.134574 0.0 +82 2.55 2.85 71.25 0.00323495 -0.2024 -0.00313048 -0.169997 0.202387 0.169981 0.0 +83 2.55 2.85 78.75 0.0415278 -0.0778296 -0.0414056 -0.213315 0.077898 0.213326 0.0 +84 2.55 2.85 86.25 0.131889 0.069504 -0.132199 -0.248098 -0.0695577 0.248098 0.0 +85 2.55 2.85 93.75 0.214594 0.193542 -0.214655 -0.244475 -0.193398 0.244477 0.0 +86 2.55 2.85 101.25 0.244494 0.247624 -0.244635 -0.195685 -0.247697 0.195696 0.0 +87 2.55 2.85 108.75 0.201434 0.218545 -0.201617 -0.114828 -0.218615 0.114846 0.0 +88 2.55 2.85 116.25 0.0998591 0.127904 -0.0997024 -0.024899 -0.127956 0.0249269 0.0 +89 2.55 2.85 123.75 -0.0181479 0.0163555 0.0181766 0.049407 -0.0163067 -0.0494209 0.0 +90 2.55 2.85 131.25 -0.11898 -0.0876934 0.119352 0.098005 0.0875449 -0.0979311 0.0 +91 2.55 2.85 138.75 -0.214707 -0.191866 0.214605 0.134596 0.191898 -0.13457 0.0 +92 2.55 2.85 146.25 -0.347993 -0.330815 0.348041 0.185048 0.330869 -0.185107 0.0 +93 2.55 2.85 153.75 -0.550177 -0.528952 0.549981 0.265291 0.528797 -0.265232 0.0 +94 2.55 2.85 161.25 -0.804311 -0.769737 0.804194 0.367848 0.769696 -0.367861 0.0 +95 2.55 2.85 168.75 -1.04529 -0.994652 1.04554 0.465186 0.99499 -0.465282 0.0 +96 2.55 2.85 176.25 -1.19281 -1.13166 1.19305 0.52457 1.13177 -0.524594 0.0 +97 2.55 2.95 3.75 -419.502 -582.296 419.502 8332.23 582.296 -8332.23 0.0 +98 2.55 2.95 11.25 -271.55 -404.417 271.55 3930.48 404.417 -3930.48 0.0 +99 2.55 2.95 18.75 -130.928 -214.969 130.928 1464.2 214.969 -1464.2 0.0 +100 2.55 2.95 26.25 -48.786 -88.4342 48.786 447.646 88.4342 -447.646 0.0 +101 2.55 2.95 33.75 -14.3964 -27.3665 14.3964 104.519 27.3665 -104.519 0.0 +102 2.55 2.95 41.25 -3.7883 -6.20808 3.78827 16.4944 6.20806 -16.4944 0.0 +103 2.55 2.95 48.75 -1.0529 -1.19869 1.05292 1.27167 1.19863 -1.27161 0.0 +104 2.55 2.95 56.25 -0.231522 -0.429682 0.231513 -0.0951674 0.429629 0.0951268 0.0 +105 2.55 2.95 63.75 0.0181127 -0.325032 -0.0180919 -0.110423 0.324922 0.110426 0.0 +106 2.55 2.95 71.25 0.049094 -0.246096 -0.0491496 -0.144969 0.245996 0.14495 0.0 +107 2.55 2.95 78.75 0.063364 -0.114463 -0.0633467 -0.196803 0.114426 0.196797 0.0 +108 2.55 2.95 86.25 0.11583 0.0385036 -0.115786 -0.223948 -0.0384687 0.223952 0.0 +109 2.55 2.95 93.75 0.177943 0.156855 -0.178064 -0.209887 -0.156845 0.209889 0.0 +110 2.55 2.95 101.25 0.207654 0.212381 -0.207593 -0.163549 -0.212444 0.163567 0.0 +111 2.55 2.95 108.75 0.175031 0.201414 -0.174609 -0.0967898 -0.20124 0.0967398 0.0 +112 2.55 2.95 116.25 0.0862557 0.136066 -0.0862066 -0.0233966 -0.13596 0.0233258 0.0 +113 2.55 2.95 123.75 -0.0191239 0.0441682 0.0193287 0.0382847 -0.0441811 -0.0382953 0.0 +114 2.55 2.95 131.25 -0.110069 -0.050979 0.109801 0.0798251 0.0509319 -0.0799025 0.0 +115 2.55 2.95 138.75 -0.196213 -0.153394 0.196102 0.113373 0.153405 -0.113396 0.0 +116 2.55 2.95 146.25 -0.318885 -0.291367 0.319145 0.161467 0.291373 -0.161505 0.0 +117 2.55 2.95 153.75 -0.50686 -0.483737 0.506732 0.236963 0.48342 -0.236818 0.0 +118 2.55 2.95 161.25 -0.742764 -0.712982 0.742837 0.331712 0.713077 -0.331758 0.0 +119 2.55 2.95 168.75 -0.965814 -0.924655 0.965837 0.420445 0.924729 -0.420487 0.0 +120 2.55 2.95 176.25 -1.10185 -1.05258 1.10198 0.474136 1.05241 -0.474051 0.0 +121 2.55 3.05 3.75 -319.111 -440.938 319.111 6126.66 440.938 -6126.66 0.0 +122 2.55 3.05 11.25 -200.795 -309.049 200.795 3169.23 309.049 -3169.23 0.0 +123 2.55 3.05 18.75 -86.7152 -162.683 86.7152 1211.49 162.683 -1211.49 0.0 +124 2.55 3.05 26.25 -24.7922 -65.0953 24.7921 363.733 65.0953 -363.733 0.0 +125 2.55 3.05 33.75 -3.79557 -19.4403 3.79568 80.4622 19.4403 -80.4622 0.0 +126 2.55 3.05 41.25 -0.227488 -4.40816 0.227381 11.3442 4.40812 -11.3442 0.0 +127 2.55 3.05 48.75 -0.215962 -0.9846 0.21623 0.572809 0.984607 -0.572833 0.0 +128 2.55 3.05 56.25 -0.0972827 -0.406271 0.0971886 -0.155442 0.406388 0.155438 0.0 +129 2.55 3.05 63.75 0.0474691 -0.320721 -0.0473142 -0.115525 0.320742 0.115541 0.0 +130 2.55 3.05 71.25 0.0542543 -0.274312 -0.0545515 -0.127569 0.274174 0.127517 0.0 +131 2.55 3.05 78.75 0.0439985 -0.158092 -0.0440511 -0.165185 0.158055 0.165194 0.0 +132 2.55 3.05 86.25 0.0821507 -0.00877884 -0.0821081 -0.183829 0.00887135 0.183832 0.0 +133 2.55 3.05 93.75 0.142245 0.109192 -0.142406 -0.168613 -0.109223 0.168609 0.0 +134 2.55 3.05 101.25 0.176786 0.175042 -0.176859 -0.131259 -0.174989 0.13127 0.0 +135 2.55 3.05 108.75 0.153044 0.185839 -0.153188 -0.0796497 -0.185913 0.0796723 0.0 +136 2.55 3.05 116.25 0.0762661 0.144574 -0.0760233 -0.0213083 -0.14475 0.0213947 0.0 +137 2.55 3.05 123.75 -0.0153973 0.0697421 0.0151775 0.0294442 -0.0697414 -0.0295136 0.0 +138 2.55 3.05 131.25 -0.0914496 -0.0164558 0.0915457 0.0650391 0.01638 -0.0650155 0.0 +139 2.55 3.05 138.75 -0.163525 -0.114278 0.163505 0.0952572 0.113968 -0.0951433 0.0 +140 2.55 3.05 146.25 -0.267879 -0.245016 0.267903 0.138326 0.244925 -0.138338 0.0 +141 2.55 3.05 153.75 -0.430018 -0.423265 0.429956 0.203867 0.423326 -0.203942 0.0 +142 2.55 3.05 161.25 -0.633833 -0.631774 0.634037 0.284186 0.631568 -0.284063 0.0 +143 2.55 3.05 168.75 -0.826685 -0.82183 0.826375 0.358252 0.82172 -0.358225 0.0 +144 2.55 3.05 176.25 -0.943422 -0.93572 0.943723 0.402697 0.935847 -0.402743 0.0 +145 2.55 3.15 3.75 -249.767 -271.418 249.767 4425.44 271.418 -4425.44 0.0 +146 2.55 3.15 11.25 -154.5 -187.982 154.5 2434.18 187.982 -2434.18 0.0 +147 2.55 3.15 18.75 -60.5981 -94.4639 60.5982 946.499 94.4639 -946.499 0.0 +148 2.55 3.15 26.25 -11.8534 -34.6155 11.8535 277.025 34.6156 -277.025 0.0 +149 2.55 3.15 33.75 1.6123 -9.2646 -1.61231 57.3974 9.26465 -57.3974 0.0 +150 2.55 3.15 41.25 1.60158 -2.19805 -1.60158 7.12692 2.19808 -7.12698 0.0 +151 2.55 3.15 48.75 0.26948 -0.778894 -0.269488 0.21063 0.778852 -0.210617 0.0 +152 2.55 3.15 56.25 -0.01372 -0.412911 0.0136807 -0.142081 0.412893 0.142164 0.0 +153 2.55 3.15 63.75 0.0224038 -0.329718 -0.0222862 -0.0965871 0.329602 0.096574 0.0 +154 2.55 3.15 71.25 0.0060749 -0.316094 -0.00598008 -0.0883032 0.316076 0.0883122 0.0 +155 2.55 3.15 78.75 0.00302628 -0.219142 -0.00292645 -0.117193 0.219165 0.117188 0.0 +156 2.55 3.15 86.25 0.0523024 -0.0705546 -0.0522252 -0.136651 0.0705734 0.136649 0.0 +157 2.55 3.15 93.75 0.115651 0.0544573 -0.11564 -0.126319 -0.0545821 0.126326 0.0 +158 2.55 3.15 101.25 0.148969 0.134261 -0.149041 -0.0986894 -0.134289 0.0986837 0.0 +159 2.55 3.15 108.75 0.128464 0.165022 -0.12849 -0.0608071 -0.165301 0.0608822 0.0 +160 2.55 3.15 116.25 0.0654112 0.144738 -0.0648575 -0.0171687 -0.144771 0.0172192 0.0 +161 2.55 3.15 123.75 -0.00700089 0.0874701 0.0070514 0.0212287 -0.087399 -0.0213181 0.0 +162 2.55 3.15 131.25 -0.0630668 0.0158432 0.0629726 0.0481408 -0.0158028 -0.0482207 0.0 +163 2.55 3.15 138.75 -0.113207 -0.0669731 0.112947 0.0710475 0.0668196 -0.0709779 0.0 +164 2.55 3.15 146.25 -0.189616 -0.177294 0.189595 0.103802 0.177145 -0.103761 0.0 +165 2.55 3.15 153.75 -0.313405 -0.326317 0.313385 0.153359 0.326249 -0.1534 0.0 +166 2.55 3.15 161.25 -0.471349 -0.499401 0.471384 0.2136 0.499615 -0.213641 0.0 +167 2.55 3.15 168.75 -0.621738 -0.656501 0.621526 0.268765 0.656234 -0.268609 0.0 +168 2.55 3.15 176.25 -0.713168 -0.750131 0.713075 0.301728 0.749961 -0.301587 0.0 +169 2.55 3.25 3.75 -215.533 -105.036 215.533 3115.64 105.036 -3115.64 0.0 +170 2.55 3.25 11.25 -135.709 -66.1673 135.709 1782.43 66.1673 -1782.43 0.0 +171 2.55 3.25 18.75 -53.5226 -25.2778 53.5226 697.12 25.2777 -697.12 0.0 +172 2.55 3.25 26.25 -9.76548 -4.05586 9.76548 196.405 4.05587 -196.405 0.0 +173 2.55 3.25 33.75 2.26986 0.661867 -2.26987 37.2172 -0.661895 -37.2172 0.0 +174 2.55 3.25 41.25 1.94008 -0.139655 -1.94016 3.90169 0.139693 -3.90171 0.0 +175 2.55 3.25 48.75 0.433581 -0.598298 -0.433653 0.0713369 0.598313 -0.071257 0.0 +176 2.55 3.25 56.25 -0.0110448 -0.396733 0.0111185 -0.0792235 0.396666 0.0791487 0.0 +177 2.55 3.25 63.75 -0.0512665 -0.306617 0.0511183 -0.0540821 0.306458 0.05412 0.0 +178 2.55 3.25 71.25 -0.0567327 -0.327807 0.0568023 -0.042547 0.327783 0.0424758 0.0 +179 2.55 3.25 78.75 -0.0248985 -0.256832 0.0248957 -0.0738229 0.256924 0.073814 0.0 +180 2.55 3.25 86.25 0.03699 -0.115693 -0.0368212 -0.0949395 0.115771 0.0949412 0.0 +181 2.55 3.25 93.75 0.088578 0.0114051 -0.0885974 -0.0851166 -0.0114329 0.0851098 0.0 +182 2.55 3.25 101.25 0.108379 0.100211 -0.108454 -0.0631833 -0.100386 0.0632103 0.0 +183 2.55 3.25 108.75 0.0905494 0.146067 -0.0902676 -0.0380134 -0.146103 0.0380456 0.0 +184 2.55 3.25 116.25 0.0446648 0.143011 -0.0447651 -0.0105656 -0.143148 0.0105849 0.0 +185 2.55 3.25 123.75 -0.00397982 0.102972 0.00398606 0.0132778 -0.103051 -0.0132872 0.0 +186 2.55 3.25 131.25 -0.0396488 0.0470538 0.0395149 0.0295482 -0.0468879 -0.0296284 0.0 +187 2.55 3.25 138.75 -0.0696427 -0.0184498 0.0696581 0.0434558 0.0182276 -0.0433637 0.0 +188 2.55 3.25 146.25 -0.118295 -0.104198 0.11835 0.0645889 0.104105 -0.0645169 0.0 +189 2.55 3.25 153.75 -0.201226 -0.219646 0.201381 0.0977209 0.219776 -0.0977906 0.0 +190 2.55 3.25 161.25 -0.310278 -0.35328 0.310501 0.138558 0.353454 -0.138633 0.0 +191 2.55 3.25 168.75 -0.415467 -0.474235 0.415053 0.176198 0.474086 -0.176145 0.0 +192 2.55 3.25 176.25 -0.479006 -0.546119 0.479273 0.198749 0.546279 -0.198787 0.0 +193 2.55 3.35 3.75 -204.898 28.1648 204.898 2043.28 -28.1648 -2043.28 0.0 +194 2.55 3.35 11.25 -135.949 31.6213 135.949 1195.68 -31.6213 -1195.68 0.0 +195 2.55 3.35 18.75 -60.0294 29.3309 60.0294 464.081 -29.3309 -464.081 0.0 +196 2.55 3.35 26.25 -15.5602 19.1482 15.5602 123.342 -19.1482 -123.342 0.0 +197 2.55 3.35 33.75 -0.516502 7.80361 0.516464 20.3914 -7.80361 -20.3915 0.0 +198 2.55 3.35 41.25 1.1959 1.28099 -1.1959 1.61912 -1.28089 -1.61917 0.0 +199 2.55 3.35 48.75 0.338664 -0.427486 -0.338735 0.0672361 0.427458 -0.0671949 0.0 +200 2.55 3.35 56.25 -0.0712654 -0.32692 0.0713186 -0.00513307 0.326996 0.00515152 0.0 +201 2.55 3.35 63.75 -0.121975 -0.24598 0.122164 -0.0158901 0.24595 0.0159275 0.0 +202 2.55 3.35 71.25 -0.0836168 -0.3049 0.0833968 -0.0145822 0.304962 0.0145084 0.0 +203 2.55 3.35 78.75 -0.0227775 -0.26582 0.0226797 -0.0466388 0.265827 0.0466007 0.0 +204 2.55 3.35 86.25 0.0253278 -0.141365 -0.0252494 -0.0598516 0.14135 0.0598496 0.0 +205 2.55 3.35 93.75 0.0478277 -0.0194912 -0.0477364 -0.0442668 0.01948 0.0442715 0.0 +206 2.55 3.35 101.25 0.0542989 0.072706 -0.0542353 -0.0265114 -0.0727603 0.0265457 0.0 +207 2.55 3.35 108.75 0.0474436 0.128762 -0.0473722 -0.0142292 -0.128667 0.0141884 0.0 +208 2.55 3.35 116.25 0.024829 0.139676 -0.0246836 -0.00238193 -0.139623 0.00240878 0.0 +209 2.55 3.35 123.75 -0.00477975 0.112522 0.00457921 0.00880631 -0.112295 -0.00892129 0.0 +210 2.55 3.35 131.25 -0.0290626 0.0670303 0.0288612 0.0167144 -0.0668681 -0.0167711 0.0 +211 2.55 3.35 138.75 -0.0488435 0.012812 0.048558 0.0234532 -0.0126738 -0.0236424 0.0 +212 2.55 3.35 146.25 -0.0762617 -0.0554933 0.0763255 0.0346659 0.0553813 -0.0346319 0.0 +213 2.55 3.35 153.75 -0.123726 -0.144228 0.123766 0.053841 0.144227 -0.0538008 0.0 +214 2.55 3.35 161.25 -0.18791 -0.245407 0.187929 0.078822 0.245764 -0.079086 0.0 +215 2.55 3.35 168.75 -0.251038 -0.336304 0.251286 0.102654 0.336317 -0.102638 0.0 +216 2.55 3.35 176.25 -0.29084 -0.390314 0.290697 0.117217 0.390531 -0.11737 0.0 +217 2.55 3.45 3.75 -160.11 78.3904 160.11 964.746 -78.3904 -964.746 0.0 +218 2.55 3.45 11.25 -112.253 65.2155 112.253 569.896 -65.2155 -569.896 0.0 +219 2.55 3.45 18.75 -55.5875 44.2652 55.5876 216.275 -44.2652 -216.275 0.0 +220 2.55 3.45 26.25 -18.577 23.1948 18.5771 52.7785 -23.1948 -52.7785 0.0 +221 2.55 3.45 33.75 -3.3749 8.35207 3.37496 7.08855 -8.35205 -7.08857 0.0 +222 2.55 3.45 41.25 0.0558271 1.43995 -0.0557888 0.416872 -1.44003 -0.416798 0.0 +223 2.55 3.45 48.75 0.0736874 -0.250918 -0.0736577 0.137694 0.25083 -0.137688 0.0 +224 2.55 3.45 56.25 -0.118382 -0.234235 0.118498 0.029723 0.234224 -0.0297093 0.0 +225 2.55 3.45 63.75 -0.103993 -0.193692 0.103998 -0.0111831 0.193659 0.0111847 0.0 +226 2.55 3.45 71.25 -0.0373239 -0.248873 0.0374 -0.0103758 0.248904 0.0103568 0.0 +227 2.55 3.45 78.75 -0.000815577 -0.221711 0.000857674 -0.0239127 0.221702 0.0239331 0.0 +228 2.55 3.45 86.25 0.00235137 -0.12606 -0.00247045 -0.0235691 0.126024 0.0235785 0.0 +229 2.55 3.45 93.75 0.000693468 -0.0322758 -0.000731622 -0.0100368 0.0322426 0.0100472 0.0 +230 2.55 3.45 101.25 0.0107898 0.0378694 -0.0109773 -0.00230259 -0.0379779 0.00230944 0.0 +231 2.55 3.45 108.75 0.0223901 0.0828189 -0.0224924 -0.0011966 -0.0828617 0.00119886 0.0 +232 2.55 3.45 116.25 0.01901 0.0976112 -0.0189845 0.000576941 -0.0977212 -0.000592258 0.0 +233 2.55 3.45 123.75 0.0023177 0.0865526 -0.00220076 0.00381654 -0.0867258 -0.00376165 0.0 +234 2.55 3.45 131.25 -0.0137084 0.0618094 0.0137112 0.00514774 -0.0618168 -0.00513733 0.0 +235 2.55 3.45 138.75 -0.0208603 0.0307928 0.0209021 0.00395318 -0.0306512 -0.00401619 0.0 +236 2.55 3.45 146.25 -0.0246671 -0.00894626 0.0246851 0.00351226 0.00893543 -0.0035253 0.0 +237 2.55 3.45 153.75 -0.0354818 -0.0611658 0.0352745 0.0074458 0.0613979 -0.00758451 0.0 +238 2.55 3.45 161.25 -0.0568268 -0.12175 0.0568015 0.016221 0.121744 -0.0162267 0.0 +239 2.55 3.45 168.75 -0.0825887 -0.177017 0.0826212 0.0265372 0.177062 -0.0266112 0.0 +240 2.55 3.45 176.25 -0.100362 -0.210215 0.100363 0.0334528 0.210225 -0.0334721 0.0 +241 2.55 3.55 3.75 -78.9919 44.1593 78.9919 272.44 -44.1593 -272.44 0.0 +242 2.55 3.55 11.25 -57.4405 35.3664 57.4405 160.985 -35.3664 -160.985 0.0 +243 2.55 3.55 18.75 -30.4327 22.6574 30.4327 59.1789 -22.6574 -59.1789 0.0 +244 2.55 3.55 26.25 -11.3918 11.2259 11.3918 13.1796 -11.2259 -13.1796 0.0 +245 2.55 3.55 33.75 -2.72329 3.8781 2.7233 1.57893 -3.87813 -1.57891 0.0 +246 2.55 3.55 41.25 -0.349405 0.648596 0.349417 0.278163 -0.648614 -0.278143 0.0 +247 2.55 3.55 48.75 -0.0951034 -0.129698 0.0950942 0.144918 0.129704 -0.144907 0.0 +248 2.55 3.55 56.25 -0.0904303 -0.132617 0.0904025 -0.000622582 0.13263 0.000613981 0.0 +249 2.55 3.55 63.75 -0.0258623 -0.110734 0.0258374 -0.0284537 0.110749 0.0284432 0.0 +250 2.55 3.55 71.25 0.0130336 -0.121492 -0.0129784 -0.00958708 0.121519 0.0095864 0.0 +251 2.55 3.55 78.75 0.00216509 -0.0947175 -0.00212262 -0.00146876 0.0947229 0.0014866 0.0 +252 2.55 3.55 86.25 -0.0193046 -0.044118 0.0193305 0.000949206 0.0440946 -0.000951166 0.0 +253 2.55 3.55 93.75 -0.0204643 -0.00523306 0.0203838 0.00128217 0.00527308 -0.00128181 0.0 +254 2.55 3.55 101.25 -0.00377452 0.0162146 0.00374878 -0.00203826 -0.0161878 0.00203335 0.0 +255 2.55 3.55 108.75 0.0103855 0.0283922 -0.0103646 -0.00590355 -0.0284035 0.0059097 0.0 +256 2.55 3.55 116.25 0.0107496 0.0355757 -0.0107487 -0.00748469 -0.0355346 0.00746902 0.0 +257 2.55 3.55 123.75 0.00390058 0.039282 -0.00394485 -0.00836899 -0.0392871 0.00836606 0.0 +258 2.55 3.55 131.25 0.00302193 0.0417158 -0.00303302 -0.0116169 -0.0417316 0.0116365 0.0 +259 2.55 3.55 138.75 0.0132809 0.0429902 -0.0132594 -0.0177461 -0.0429583 0.0177101 0.0 +260 2.55 3.55 146.25 0.0286472 0.040296 -0.0286569 -0.0242602 -0.0403293 0.0242749 0.0 +261 2.55 3.55 153.75 0.0390318 0.0306394 -0.039064 -0.0280589 -0.0306446 0.028059 0.0 +262 2.55 3.55 161.25 0.0394296 0.0147367 -0.0394103 -0.0279664 -0.0146398 0.0279268 0.0 +263 2.55 3.55 168.75 0.0324474 -0.00226708 -0.0324635 -0.0253945 0.00220765 0.0254368 0.0 +264 2.55 3.55 176.25 0.025994 -0.013213 -0.0260157 -0.0230769 0.0131899 0.0230844 0.0 +265 2.55 3.65 3.75 -10.2735 4.76327 10.2735 20.7201 -4.76327 -20.7201 0.0 +266 2.55 3.65 11.25 -7.59679 3.74938 7.59679 12.2716 -3.74938 -12.2716 0.0 +267 2.55 3.65 18.75 -4.13373 2.33527 4.13373 4.48711 -2.33527 -4.48711 0.0 +268 2.55 3.65 26.25 -1.60809 1.11951 1.60809 1.05798 -1.11951 -1.05798 0.0 +269 2.55 3.65 33.75 -0.426582 0.367384 0.426586 0.237798 -0.367384 -0.237797 0.0 +270 2.55 3.65 41.25 -0.0923209 0.0481501 0.0923222 0.103116 -0.0481492 -0.103116 0.0 +271 2.55 3.65 48.75 -0.0403716 -0.019861 0.0403721 0.0289419 0.0198609 -0.0289447 0.0 +272 2.55 3.65 56.25 -0.0181588 -0.0104242 0.018157 -0.0111623 0.010423 0.0111643 0.0 +273 2.55 3.65 63.75 0.0026199 -0.0022943 -0.00261809 -0.0112332 0.00229608 0.011234 0.0 +274 2.55 3.65 71.25 0.00555137 -0.00054609 -0.00554585 -0.000901878 0.000542356 0.000901001 0.0 +275 2.55 3.65 78.75 -0.00349077 0.00348611 0.00348128 0.00388527 -0.0034823 -0.00388526 0.0 +276 2.55 3.65 86.25 -0.00986876 0.00759326 0.00986851 0.00334418 -0.00759374 -0.00334402 0.0 +277 2.55 3.65 93.75 -0.00861045 0.00735376 0.00861467 0.000656354 -0.00735444 -0.000656104 0.0 +278 2.55 3.65 101.25 -0.00414524 0.00377925 0.00414321 -0.00212584 -0.00377449 0.00212561 0.0 +279 2.55 3.65 108.75 -0.00169477 0.000439308 0.00169322 -0.00396038 -0.000442715 0.00396063 0.0 +280 2.55 3.65 116.25 -0.00201868 -0.000719026 0.00201981 -0.0047974 0.000729887 0.00479364 0.0 +281 2.55 3.65 123.75 -0.0022902 0.000305603 0.00229371 -0.00529632 -0.000307648 0.00529785 0.0 +282 2.55 3.65 131.25 6.5658e-05 0.00293592 -6.35245e-05 -0.00609152 -0.00294529 0.00609664 0.0 +283 2.55 3.65 138.75 0.00496513 0.00653024 -0.0049612 -0.00723673 -0.00653204 0.00723752 0.0 +284 2.55 3.65 146.25 0.0100844 0.0103162 -0.0100899 -0.0082568 -0.0103134 0.00825192 0.0 +285 2.55 3.65 153.75 0.013056 0.0135185 -0.0130568 -0.00863418 -0.0135186 0.00863497 0.0 +286 2.55 3.65 161.25 0.0130732 0.0156428 -0.013084 -0.00825131 -0.0156473 0.00825326 0.0 +287 2.55 3.65 168.75 0.0112797 0.0167179 -0.0112803 -0.00747124 -0.0167224 0.00747658 0.0 +288 2.55 3.65 176.25 0.0096521 0.0170897 -0.00964981 -0.00687278 -0.0170876 0.00686999 0.0 +289 2.65 2.55 3.75 -799.674 -712.655 799.674 18807.8 712.655 -18807.8 0.0 +290 2.65 2.55 11.25 -525.625 -475.265 525.625 4994.59 475.265 -4994.59 0.0 +291 2.65 2.55 18.75 -295.846 -269.889 295.846 1679.59 269.889 -1679.59 0.0 +292 2.65 2.55 26.25 -143.669 -131.164 143.669 522.387 131.164 -522.387 0.0 +293 2.65 2.55 33.75 -60.2595 -54.4807 60.2595 136.208 54.4807 -136.208 0.0 +294 2.65 2.55 41.25 -21.6186 -19.006 21.6186 29.1359 19.006 -29.1359 0.0 +295 2.65 2.55 48.75 -6.2004 -4.98522 6.20039 5.36148 4.98526 -5.3615 0.0 +296 2.65 2.55 56.25 -0.973428 -0.39018 0.973324 0.482318 0.390219 -0.482323 0.0 +297 2.65 2.55 63.75 0.314211 0.536906 -0.314193 -0.589646 -0.536928 0.58965 0.0 +298 2.65 2.55 71.25 0.35202 0.378507 -0.352079 -0.582078 -0.378534 0.582099 0.0 +299 2.65 2.55 78.75 0.201526 0.217522 -0.201635 -0.39221 -0.217499 0.392213 0.0 +300 2.65 2.55 86.25 0.158101 0.284677 -0.15805 -0.345984 -0.284628 0.345996 0.0 +301 2.65 2.55 93.75 0.194955 0.4204 -0.194905 -0.359053 -0.420368 0.359041 0.0 +302 2.65 2.55 101.25 0.217278 0.451611 -0.217168 -0.302903 -0.451706 0.302904 0.0 +303 2.65 2.55 108.75 0.177459 0.346261 -0.177385 -0.174633 -0.34637 0.174667 0.0 +304 2.65 2.55 116.25 0.0932406 0.177749 -0.093405 -0.0419077 -0.177758 0.0419259 0.0 +305 2.65 2.55 123.75 0.0143374 0.03145 -0.0145507 0.0454119 -0.0313795 -0.045448 0.0 +306 2.65 2.55 131.25 -0.0346536 -0.0608535 0.0348124 0.0869938 0.0609483 -0.0870298 0.0 +307 2.65 2.55 138.75 -0.0817334 -0.132275 0.0817107 0.117066 0.132252 -0.11706 0.0 +308 2.65 2.55 146.25 -0.184555 -0.244924 0.18477 0.173455 0.244919 -0.173443 0.0 +309 2.65 2.55 153.75 -0.380746 -0.438659 0.380787 0.272485 0.438786 -0.272543 0.0 +310 2.65 2.55 161.25 -0.649138 -0.696616 0.649172 0.400228 0.696703 -0.400289 0.0 +311 2.65 2.55 168.75 -0.912684 -0.947747 0.912894 0.520664 0.947624 -0.520601 0.0 +312 2.65 2.55 176.25 -1.07651 -1.10339 1.07652 0.593714 1.10339 -0.593746 0.0 +313 2.65 2.65 3.75 -850.9 -766.532 850.9 24206.3 766.532 -24206.3 0.0 +314 2.65 2.65 11.25 -532.471 -481.095 532.471 5590.03 481.095 -5590.03 0.0 +315 2.65 2.65 18.75 -284.368 -250.886 284.368 1834.01 250.886 -1834.01 0.0 +316 2.65 2.65 26.25 -129.075 -106.598 129.075 555.283 106.598 -555.283 0.0 +317 2.65 2.65 33.75 -49.9399 -36.5293 49.9399 138.315 36.5293 -138.315 0.0 +318 2.65 2.65 41.25 -16.5129 -10.4032 16.5129 27.2019 10.4033 -27.2019 0.0 +319 2.65 2.65 48.75 -4.46528 -2.7076 4.46539 4.42411 2.70761 -4.42411 0.0 +320 2.65 2.65 56.25 -0.741021 -0.597377 0.741105 0.305553 0.597353 -0.305549 0.0 +321 2.65 2.65 63.75 0.104606 0.0237456 -0.104669 -0.572899 -0.0237444 0.572894 0.0 +322 2.65 2.65 71.25 0.139391 0.125946 -0.139515 -0.571709 -0.125927 0.571698 0.0 +323 2.65 2.65 78.75 0.104219 0.102894 -0.104113 -0.382665 -0.102882 0.382676 0.0 +324 2.65 2.65 86.25 0.157087 0.145852 -0.157232 -0.297431 -0.1459 0.297442 0.0 +325 2.65 2.65 93.75 0.240407 0.236266 -0.240541 -0.278188 -0.236265 0.27819 0.0 +326 2.65 2.65 101.25 0.275238 0.279291 -0.274988 -0.229799 -0.27936 0.229805 0.0 +327 2.65 2.65 108.75 0.227141 0.229356 -0.227284 -0.134968 -0.229285 0.134932 0.0 +328 2.65 2.65 116.25 0.115892 0.112442 -0.115868 -0.0291153 -0.112422 0.0291383 0.0 +329 2.65 2.65 123.75 -0.010285 -0.0162117 0.0103961 0.0530193 0.0161505 -0.0529991 0.0 +330 2.65 2.65 131.25 -0.1188 -0.124881 0.118875 0.104487 0.124916 -0.104492 0.0 +331 2.65 2.65 138.75 -0.223058 -0.229731 0.223369 0.145724 0.229737 -0.145685 0.0 +332 2.65 2.65 146.25 -0.368701 -0.376052 0.368859 0.205686 0.3761 -0.205685 0.0 +333 2.65 2.65 153.75 -0.587337 -0.594228 0.587423 0.299459 0.594372 -0.299509 0.0 +334 2.65 2.65 161.25 -0.859864 -0.865453 0.859988 0.416736 0.865344 -0.416708 0.0 +335 2.65 2.65 168.75 -1.11756 -1.12156 1.11739 0.526563 1.12147 -0.526502 0.0 +336 2.65 2.65 176.25 -1.2751 -1.27817 1.27506 0.593124 1.2781 -0.593061 0.0 +337 2.65 2.75 3.75 -835.182 -772.341 835.182 21905.9 772.341 -21905.9 0.0 +338 2.65 2.75 11.25 -513.694 -481.73 513.694 5723.06 481.73 -5723.06 0.0 +339 2.65 2.75 18.75 -261.725 -240.477 261.725 1876.13 240.477 -1876.13 0.0 +340 2.65 2.75 26.25 -110.82 -93.042 110.82 555.313 93.0419 -555.313 0.0 +341 2.65 2.75 33.75 -39.2645 -26.3478 39.2645 131.64 26.3478 -131.64 0.0 +342 2.65 2.75 41.25 -11.8937 -5.23302 11.8938 23.3148 5.233 -23.3148 0.0 +343 2.65 2.75 48.75 -3.05671 -0.993603 3.05657 3.14407 0.993621 -3.14406 0.0 +344 2.65 2.75 56.25 -0.550099 -0.358525 0.550227 0.163089 0.358498 -0.163112 0.0 +345 2.65 2.75 63.75 -0.0205929 -0.0842747 0.0205161 -0.407995 0.0842518 0.407956 0.0 +346 2.65 2.75 71.25 0.00336668 0.0345981 -0.00349936 -0.421497 -0.0346157 0.421506 0.0 +347 2.65 2.75 78.75 0.0253619 0.0593683 -0.0255874 -0.3063 -0.0593531 0.306294 0.0 +348 2.65 2.75 86.25 0.119248 0.114375 -0.119305 -0.255219 -0.114285 0.255229 0.0 +349 2.65 2.75 93.75 0.216069 0.202657 -0.216049 -0.241183 -0.202733 0.241187 0.0 +350 2.65 2.75 101.25 0.255314 0.253769 -0.255148 -0.201128 -0.253738 0.20113 0.0 +351 2.65 2.75 108.75 0.214511 0.222856 -0.214525 -0.121963 -0.222827 0.121965 0.0 +352 2.65 2.75 116.25 0.110921 0.123065 -0.110896 -0.0278056 -0.123096 0.027821 0.0 +353 2.65 2.75 123.75 -0.0119931 0.00216882 0.0119589 0.0508731 -0.00227192 -0.0508543 0.0 +354 2.65 2.75 131.25 -0.119575 -0.104676 0.119555 0.102045 0.10466 -0.10204 0.0 +355 2.65 2.75 138.75 -0.220603 -0.205567 0.220425 0.139953 0.205519 -0.139884 0.0 +356 2.65 2.75 146.25 -0.354901 -0.339963 0.354916 0.191191 0.340301 -0.191375 0.0 +357 2.65 2.75 153.75 -0.553233 -0.537535 0.553233 0.27207 0.537478 -0.272051 0.0 +358 2.65 2.75 161.25 -0.800056 -0.783314 0.80005 0.37528 0.783269 -0.375219 0.0 +359 2.65 2.75 168.75 -1.03362 -1.01636 1.03349 0.473222 1.01637 -0.473237 0.0 +360 2.65 2.75 176.25 -1.17633 -1.15917 1.17626 0.532997 1.15938 -0.533141 0.0 +361 2.65 2.85 3.75 -760.67 -716.576 760.67 16548.2 716.576 -16548.2 0.0 +362 2.65 2.85 11.25 -468.577 -458.252 468.577 5405.79 458.252 -5405.79 0.0 +363 2.65 2.85 18.75 -228.053 -226.497 228.053 1802.81 226.497 -1802.81 0.0 +364 2.65 2.85 26.25 -89.1662 -84.2911 89.1663 523.528 84.2911 -523.528 0.0 +365 2.65 2.85 33.75 -28.2756 -21.661 28.2757 117.98 21.661 -117.98 0.0 +366 2.65 2.85 41.25 -7.65848 -3.29349 7.65854 18.6016 3.29345 -18.6016 0.0 +367 2.65 2.85 48.75 -1.87861 -0.425521 1.87855 1.91342 0.425548 -1.91344 0.0 +368 2.65 2.85 56.25 -0.359414 -0.305329 0.359467 0.0202548 0.305288 -0.0202399 0.0 +369 2.65 2.85 63.75 -0.0454417 -0.184956 0.0452869 -0.276244 0.184875 0.276227 0.0 +370 2.65 2.85 71.25 -0.03328 -0.0799704 0.0333967 -0.292345 0.0799691 0.292342 0.0 +371 2.65 2.85 78.75 0.00639036 -0.0189859 -0.006449 -0.241547 0.0190153 0.241563 0.0 +372 2.65 2.85 86.25 0.102068 0.0661345 -0.102071 -0.222916 -0.0661619 0.222919 0.0 +373 2.65 2.85 93.75 0.188697 0.163968 -0.188721 -0.21219 -0.163988 0.212191 0.0 +374 2.65 2.85 101.25 0.22364 0.220472 -0.223377 -0.175014 -0.220473 0.175017 0.0 +375 2.65 2.85 108.75 0.190707 0.202776 -0.190758 -0.106231 -0.202789 0.106247 0.0 +376 2.65 2.85 116.25 0.101112 0.120884 -0.101059 -0.0239388 -0.120905 0.0239052 0.0 +377 2.65 2.85 123.75 -0.00702613 0.0160528 0.00714713 0.0453335 -0.0161052 -0.0453373 0.0 +378 2.65 2.85 131.25 -0.101648 -0.0781261 0.101387 0.088976 0.0781448 -0.0889832 0.0 +379 2.65 2.85 138.75 -0.188841 -0.166223 0.188892 0.119526 0.166146 -0.119525 0.0 +380 2.65 2.85 146.25 -0.306982 -0.284004 0.307036 0.162419 0.283915 -0.162404 0.0 +381 2.65 2.85 153.75 -0.48517 -0.45968 0.485006 0.233515 0.459501 -0.233437 0.0 +382 2.65 2.85 161.25 -0.709159 -0.680393 0.709041 0.326165 0.680286 -0.32613 0.0 +383 2.65 2.85 168.75 -0.921682 -0.890267 0.921631 0.414752 0.89028 -0.414752 0.0 +384 2.65 2.85 176.25 -1.05193 -1.01912 1.05183 0.468933 1.01918 -0.469002 0.0 +385 2.65 2.95 3.75 -652.979 -606.124 652.978 12075.3 606.124 -12075.3 0.0 +386 2.65 2.95 11.25 -403.824 -399.31 403.824 4765.3 399.31 -4765.3 0.0 +387 2.65 2.95 18.75 -187.153 -198.273 187.153 1631.6 198.273 -1631.6 0.0 +388 2.65 2.95 26.25 -66.1445 -73.0744 66.1444 465.712 73.0744 -465.712 0.0 +389 2.65 2.95 33.75 -17.7622 -18.4285 17.7623 99.7601 18.4285 -99.7601 0.0 +390 2.65 2.95 41.25 -3.98999 -2.7919 3.99011 13.9822 2.7919 -13.9822 0.0 +391 2.65 2.95 48.75 -0.962247 -0.422871 0.962286 1.0033 0.422848 -1.00329 0.0 +392 2.65 2.95 56.25 -0.219175 -0.313473 0.218952 -0.0875255 0.313511 0.0875306 0.0 +393 2.65 2.95 63.75 -0.044678 -0.231589 0.0446919 -0.204831 0.231605 0.204882 0.0 +394 2.65 2.95 71.25 -0.0396615 -0.157633 0.0394157 -0.207168 0.15761 0.207183 0.0 +395 2.65 2.95 78.75 0.000394622 -0.0817809 -0.000419789 -0.190543 0.0817504 0.19052 0.0 +396 2.65 2.95 86.25 0.0846769 0.0240518 -0.0846618 -0.190014 -0.0241096 0.19001 0.0 +397 2.65 2.95 93.75 0.158081 0.12764 -0.157821 -0.180645 -0.127555 0.18064 0.0 +398 2.65 2.95 101.25 0.189421 0.189324 -0.189292 -0.147352 -0.189274 0.147358 0.0 +399 2.65 2.95 108.75 0.164176 0.186927 -0.163977 -0.0895019 -0.186952 0.0894983 0.0 +400 2.65 2.95 116.25 0.0871432 0.125207 -0.0868669 -0.0199561 -0.125352 0.0199732 0.0 +401 2.65 2.95 123.75 -0.0085628 0.0365974 0.00860248 0.0390423 -0.0363033 -0.0391 0.0 +402 2.65 2.95 131.25 -0.0923265 -0.0482959 0.0922008 0.0760854 0.0485513 -0.0762079 0.0 +403 2.65 2.95 138.75 -0.169808 -0.131174 0.169899 0.102608 0.131327 -0.10265 0.0 +404 2.65 2.95 146.25 -0.277395 -0.242796 0.277398 0.141394 0.242783 -0.141344 0.0 +405 2.65 2.95 153.75 -0.440501 -0.407224 0.440757 0.205828 0.407133 -0.205796 0.0 +406 2.65 2.95 161.25 -0.645643 -0.610905 0.6459 0.288976 0.611281 -0.289147 0.0 +407 2.65 2.95 168.75 -0.840165 -0.802999 0.840107 0.367747 0.802858 -0.367578 0.0 +408 2.65 2.95 176.25 -0.958665 -0.920072 0.958486 0.415643 0.920088 -0.415608 0.0 +409 2.65 3.05 3.75 -535.332 -454.934 535.332 8760.56 454.934 -8760.56 0.0 +410 2.65 3.05 11.25 -331.494 -306.561 331.494 3960.52 306.561 -3960.52 0.0 +411 2.65 3.05 18.75 -145.715 -152.648 145.715 1393.82 152.648 -1393.82 0.0 +412 2.65 3.05 26.25 -45.1283 -55.696 45.1283 390.806 55.696 -390.806 0.0 +413 2.65 3.05 33.75 -9.03711 -13.9981 9.03714 79.4908 13.9982 -79.4908 0.0 +414 2.65 3.05 41.25 -1.22467 -2.35412 1.22472 9.98439 2.35415 -9.98442 0.0 +415 2.65 3.05 48.75 -0.350067 -0.498445 0.350201 0.482424 0.498397 -0.482377 0.0 +416 2.65 3.05 56.25 -0.145634 -0.296881 0.145625 -0.138328 0.296866 0.138253 0.0 +417 2.65 3.05 63.75 -0.0512301 -0.23938 0.0510461 -0.169789 0.239391 0.169777 0.0 +418 2.65 3.05 71.25 -0.0475131 -0.216688 0.0475797 -0.14914 0.21666 0.149179 0.0 +419 2.65 3.05 78.75 -0.0100019 -0.142708 0.0103876 -0.145447 0.142686 0.145453 0.0 +420 2.65 3.05 86.25 0.0629653 -0.0219697 -0.0630473 -0.155105 0.0219773 0.155114 0.0 +421 2.65 3.05 93.75 0.12664 0.0897788 -0.12658 -0.148638 -0.0897681 0.148648 0.0 +422 2.65 3.05 101.25 0.15677 0.161102 -0.15675 -0.121208 -0.161149 0.121229 0.0 +423 2.65 3.05 108.75 0.13765 0.175494 -0.137742 -0.0739815 -0.175467 0.0739654 0.0 +424 2.65 3.05 116.25 0.0719305 0.132074 -0.0719425 -0.0160117 -0.13204 0.0159808 0.0 +425 2.65 3.05 123.75 -0.0105205 0.0566312 0.0107171 0.0339816 -0.05635 -0.0341083 0.0 +426 2.65 3.05 131.25 -0.0825435 -0.0218324 0.0823353 0.0659987 0.0216974 -0.0659344 0.0 +427 2.65 3.05 138.75 -0.148847 -0.101917 0.149043 0.0897675 0.101945 -0.0897216 0.0 +428 2.65 3.05 146.25 -0.242919 -0.209388 0.242954 0.124121 0.209336 -0.12419 0.0 +429 2.65 3.05 153.75 -0.386426 -0.362461 0.386542 0.179324 0.362431 -0.179385 0.0 +430 2.65 3.05 161.25 -0.566176 -0.547526 0.566298 0.248855 0.547163 -0.248731 0.0 +431 2.65 3.05 168.75 -0.735042 -0.718844 0.735426 0.313712 0.718869 -0.313772 0.0 +432 2.65 3.05 176.25 -0.837976 -0.822371 0.837847 0.352792 0.822288 -0.352789 0.0 +433 2.65 3.15 3.75 -427.355 -285.2 427.355 6295.52 285.2 -6295.52 0.0 +434 2.65 3.15 11.25 -265.153 -194.02 265.153 3125.25 194.02 -3125.25 0.0 +435 2.65 3.15 18.75 -111.202 -95.1726 111.202 1125.35 95.1726 -1125.35 0.0 +436 2.65 3.15 26.25 -29.6517 -33.3268 29.6517 308.747 33.3268 -308.747 0.0 +437 2.65 3.15 33.75 -3.36664 -8.0325 3.36662 59.3209 8.03251 -59.3209 0.0 +438 2.65 3.15 41.25 0.370119 -1.56003 -0.370195 6.73765 1.55997 -6.73765 0.0 +439 2.65 3.15 48.75 -0.0293352 -0.505394 0.0293329 0.248728 0.505409 -0.248723 0.0 +440 2.65 3.15 56.25 -0.105843 -0.270835 0.105751 -0.145765 0.270743 0.145803 0.0 +441 2.65 3.15 63.75 -0.0513317 -0.246866 0.0514241 -0.147382 0.246878 0.147378 0.0 +442 2.65 3.15 71.25 -0.0501128 -0.275431 0.04993 -0.104001 0.275378 0.10398 0.0 +443 2.65 3.15 78.75 -0.0164568 -0.206434 0.0163659 -0.104649 0.206543 0.1047 0.0 +444 2.65 3.15 86.25 0.0461547 -0.0733023 -0.0462363 -0.11996 0.0733698 0.119964 0.0 +445 2.65 3.15 93.75 0.0990004 0.0476562 -0.0990613 -0.115936 -0.0477138 0.115929 0.0 +446 2.65 3.15 101.25 0.124404 0.129396 -0.124624 -0.0943304 -0.129428 0.0943415 0.0 +447 2.65 3.15 108.75 0.110989 0.159191 -0.110618 -0.0576564 -0.159015 0.0576196 0.0 +448 2.65 3.15 116.25 0.0587243 0.132639 -0.0587968 -0.0121644 -0.132721 0.0121638 0.0 +449 2.65 3.15 123.75 -0.00573936 0.071577 0.00545961 0.0272095 -0.0714379 -0.0272703 0.0 +450 2.65 3.15 131.25 -0.0595329 0.00372402 0.0596701 0.0523942 -0.00377444 -0.0523371 0.0 +451 2.65 3.15 138.75 -0.110101 -0.0680458 0.109914 0.0711533 0.0677435 -0.071079 0.0 +452 2.65 3.15 146.25 -0.183484 -0.162436 0.183193 0.097899 0.16187 -0.0976014 0.0 +453 2.65 3.15 153.75 -0.297201 -0.294331 0.297328 0.13994 0.294371 -0.13996 0.0 +454 2.65 3.15 161.25 -0.440022 -0.45053 0.440364 0.191997 0.45081 -0.192128 0.0 +455 2.65 3.15 168.75 -0.573979 -0.593135 0.574118 0.23999 0.593252 -0.240079 0.0 +456 2.65 3.15 176.25 -0.655332 -0.678506 0.655274 0.268714 0.678407 -0.2687 0.0 +457 2.65 3.25 3.75 -343.28 -124.107 343.28 4445.63 124.107 -4445.63 0.0 +458 2.65 3.25 11.25 -215.576 -82.5722 215.576 2350.25 82.5722 -2350.25 0.0 +459 2.65 3.25 18.75 -89.1611 -36.9434 89.1611 858.678 36.9434 -858.678 0.0 +460 2.65 3.25 26.25 -21.9322 -10.3742 21.9323 228.574 10.3742 -228.574 0.0 +461 2.65 3.25 33.75 -1.31403 -1.72106 1.31403 40.8621 1.72107 -40.8621 0.0 +462 2.65 3.25 41.25 0.795648 -0.575902 -0.795697 4.14894 0.57591 -4.14896 0.0 +463 2.65 3.25 48.75 0.0763357 -0.456169 -0.076398 0.148004 0.456256 -0.148065 0.0 +464 2.65 3.25 56.25 -0.063689 -0.249401 0.0637021 -0.13222 0.249531 0.132205 0.0 +465 2.65 3.25 63.75 -0.0358554 -0.249745 0.0359111 -0.121502 0.249724 0.121491 0.0 +466 2.65 3.25 71.25 -0.0428349 -0.311738 0.0428194 -0.0638131 0.311734 0.0637754 0.0 +467 2.65 3.25 78.75 -0.0147141 -0.250034 0.0144509 -0.0678206 0.250075 0.0677768 0.0 +468 2.65 3.25 86.25 0.0352991 -0.11503 -0.0353655 -0.0843742 0.115078 0.0843892 0.0 +469 2.65 3.25 93.75 0.0720144 0.00909964 -0.0719435 -0.0804605 -0.0090581 0.0804531 0.0 +470 2.65 3.25 101.25 0.0888655 0.0989902 -0.0887325 -0.0647524 -0.0990223 0.0647474 0.0 +471 2.65 3.25 108.75 0.0799171 0.143831 -0.0801351 -0.0405357 -0.143865 0.0405626 0.0 +472 2.65 3.25 116.25 0.0463151 0.13551 -0.0462271 -0.0103342 -0.135713 0.0104217 0.0 +473 2.65 3.25 123.75 0.00341445 0.0908375 -0.00340467 0.0161085 -0.0908948 -0.0161034 0.0 +474 2.65 3.25 131.25 -0.0328772 0.0354199 0.0327234 0.0332693 -0.0353895 -0.0333584 0.0 +475 2.65 3.25 138.75 -0.0675007 -0.0244596 0.0674606 0.0466046 0.0245277 -0.0466162 0.0 +476 2.65 3.25 146.25 -0.119973 -0.102745 0.119865 0.0658272 0.102678 -0.0658241 0.0 +477 2.65 3.25 153.75 -0.201674 -0.208813 0.202075 0.0954721 0.209073 -0.0955902 0.0 +478 2.65 3.25 161.25 -0.304347 -0.332116 0.304539 0.131641 0.332258 -0.131649 0.0 +479 2.65 3.25 168.75 -0.400265 -0.443353 0.400058 0.164689 0.443498 -0.164816 0.0 +480 2.65 3.25 176.25 -0.458148 -0.509414 0.458013 0.184384 0.509501 -0.184446 0.0 +481 2.65 3.35 3.75 -278.227 3.35188 278.227 2946.21 -3.35188 -2946.21 0.0 +482 2.65 3.35 11.25 -180.202 7.30679 180.202 1622.2 -7.30679 -1622.2 0.0 +483 2.65 3.35 18.75 -77.9402 10.1339 77.9402 594.724 -10.1339 -594.724 0.0 +484 2.65 3.35 26.25 -20.9467 8.02501 20.9466 151.361 -8.02502 -151.361 0.0 +485 2.65 3.35 33.75 -2.25835 3.3951 2.25826 24.3523 -3.39512 -24.3522 0.0 +486 2.65 3.35 41.25 0.363524 0.335418 -0.363448 2.07799 -0.335341 -2.07804 0.0 +487 2.65 3.35 48.75 0.0599237 -0.367988 -0.059957 0.0931953 0.367953 -0.0931855 0.0 +488 2.65 3.35 56.25 -0.0236982 -0.242143 0.0236458 -0.098598 0.242167 0.0985908 0.0 +489 2.65 3.35 63.75 -0.0239201 -0.250568 0.023879 -0.0793347 0.250659 0.0793004 0.0 +490 2.65 3.35 71.25 -0.0368509 -0.319915 0.0367806 -0.0239745 0.319926 0.0239988 0.0 +491 2.65 3.35 78.75 -0.0110244 -0.268487 0.0110139 -0.0344337 0.268438 0.0344165 0.0 +492 2.65 3.35 86.25 0.0245226 -0.144794 -0.024666 -0.0497857 0.144602 0.0497966 0.0 +493 2.65 3.35 93.75 0.0424081 -0.0251599 -0.0424651 -0.0453306 0.0251858 0.0453233 0.0 +494 2.65 3.35 101.25 0.04903 0.0707895 -0.0493151 -0.0359067 -0.0707318 0.0358776 0.0 +495 2.65 3.35 108.75 0.0471092 0.130164 -0.0471373 -0.0244748 -0.130189 0.0244837 0.0 +496 2.65 3.35 116.25 0.0314376 0.139837 -0.0314698 -0.00916072 -0.139805 0.00913728 0.0 +497 2.65 3.35 123.75 0.00660309 0.109671 -0.00661976 0.00590828 -0.109418 -0.00599612 0.0 +498 2.65 3.35 131.25 -0.0184331 0.0620534 0.0189306 0.0173272 -0.0619207 -0.0174002 0.0 +499 2.65 3.35 138.75 -0.0453275 0.00760214 0.0452428 0.0275525 -0.00734601 -0.027681 0.0 +500 2.65 3.35 146.25 -0.082266 -0.0599492 0.082171 0.0416578 0.0599927 -0.0416724 0.0 +501 2.65 3.35 153.75 -0.136274 -0.146184 0.136402 0.0620795 0.146055 -0.0619743 0.0 +502 2.65 3.35 161.25 -0.202661 -0.24297 0.20278 0.086379 0.243041 -0.0864087 0.0 +503 2.65 3.35 168.75 -0.264667 -0.328848 0.264622 0.108466 0.328816 -0.108439 0.0 +504 2.65 3.35 176.25 -0.302166 -0.379469 0.302333 0.121649 0.379451 -0.121585 0.0 +505 2.65 3.45 3.75 -181.094 56.5768 181.094 1415.07 -56.5768 -1415.07 0.0 +506 2.65 3.45 11.25 -122.646 43.7184 122.646 798.081 -43.7184 -798.081 0.0 +507 2.65 3.45 18.75 -57.6293 27.3547 57.6292 289.903 -27.3547 -289.903 0.0 +508 2.65 3.45 26.25 -18.2701 13.6208 18.2701 69.1213 -13.6207 -69.1213 0.0 +509 2.65 3.45 33.75 -3.43227 4.75555 3.43223 9.49818 -4.75554 -9.49816 0.0 +510 2.65 3.45 41.25 -0.262119 0.743592 0.262138 0.642703 -0.743569 -0.64265 0.0 +511 2.65 3.45 48.75 -0.0206249 -0.220801 0.0206949 0.0833427 0.220803 -0.0833703 0.0 +512 2.65 3.45 56.25 -0.0278092 -0.219147 0.0277268 -0.0418895 0.219207 0.0419362 0.0 +513 2.65 3.45 63.75 -0.0302865 -0.221675 0.0303371 -0.0292143 0.221725 0.0292088 0.0 +514 2.65 3.45 71.25 -0.0283973 -0.257992 0.0284536 0.00362643 0.257937 -0.00359012 0.0 +515 2.65 3.45 78.75 -0.00583895 -0.217814 0.00603552 -0.0105431 0.217741 0.0105389 0.0 +516 2.65 3.45 86.25 0.0119324 -0.129526 -0.0119649 -0.0224338 0.129557 0.0224452 0.0 +517 2.65 3.45 93.75 0.0144366 -0.0428903 -0.0145475 -0.0187179 0.0429014 0.0187299 0.0 +518 2.65 3.45 101.25 0.0149629 0.0297917 -0.015042 -0.0130715 -0.0298841 0.013074 0.0 +519 2.65 3.45 108.75 0.0176727 0.0802808 -0.0176481 -0.00859687 -0.0801128 0.00854075 0.0 +520 2.65 3.45 116.25 0.0142801 0.0968509 -0.0142142 -0.00275531 -0.0968446 0.00279613 0.0 +521 2.65 3.45 123.75 0.00274599 0.0822463 -0.00285046 0.00385754 -0.0822624 -0.00387098 0.0 +522 2.65 3.45 131.25 -0.0115459 0.0508246 0.0116421 0.00941126 -0.0506893 -0.00950556 0.0 +523 2.65 3.45 138.75 -0.0256544 0.0123774 0.0254092 0.0140698 -0.0124329 -0.0139752 0.0 +524 2.65 3.45 146.25 -0.0416502 -0.0338945 0.0416358 0.0199093 0.0339039 -0.0199382 0.0 +525 2.65 3.45 153.75 -0.06548 -0.0902951 0.0654101 0.02876 0.0902214 -0.0286754 0.0 +526 2.65 3.45 161.25 -0.0968618 -0.152516 0.096841 0.0402396 0.152761 -0.0403307 0.0 +527 2.65 3.45 168.75 -0.128132 -0.207768 0.128088 0.0514288 0.207796 -0.0514167 0.0 +528 2.65 3.45 176.25 -0.147889 -0.240577 0.147879 0.058392 0.24052 -0.0584226 0.0 +529 2.65 3.55 3.75 -77.1979 33.0526 77.1979 408.269 -33.0526 -408.269 0.0 +530 2.65 3.55 11.25 -54.4456 24.806 54.4456 233.071 -24.806 -233.071 0.0 +531 2.65 3.55 18.75 -27.4729 14.6982 27.4729 83.0823 -14.6982 -83.0823 0.0 +532 2.65 3.55 26.25 -9.74029 6.98034 9.74028 18.3878 -6.98034 -18.3878 0.0 +533 2.65 3.55 33.75 -2.26688 2.44976 2.26686 2.2212 -2.44975 -2.22122 0.0 +534 2.65 3.55 41.25 -0.338901 0.452784 0.338876 0.250018 -0.452783 -0.250042 0.0 +535 2.65 3.55 48.75 -0.085801 -0.0837087 0.0858276 0.0833161 0.0837009 -0.0833153 0.0 +536 2.65 3.55 56.25 -0.053787 -0.114074 0.0537453 -0.0208865 0.114083 0.0208809 0.0 +537 2.65 3.55 63.75 -0.0249841 -0.102636 0.0249818 -0.0169731 0.102618 0.0169814 0.0 +538 2.65 3.55 71.25 -0.00793484 -0.104993 0.0079199 0.00243536 0.104968 -0.00244121 0.0 +539 2.65 3.55 78.75 0.000477289 -0.083635 -0.000473373 -0.0028304 0.083634 0.00283354 0.0 +540 2.65 3.55 86.25 0.00225691 -0.0484377 -0.00227501 -0.00865479 0.0484012 0.00865592 0.0 +541 2.65 3.55 93.75 0.00072074 -0.0198074 -0.000659016 -0.00641186 0.0197662 0.00641637 0.0 +542 2.65 3.55 101.25 0.00112223 0.00094823 -0.0011259 -0.00217623 -0.000927796 0.00217226 0.0 +543 2.65 3.55 108.75 0.00303859 0.0169456 -0.0030474 0.000636489 -0.0170012 -0.000616911 0.0 +544 2.65 3.55 116.25 0.00293939 0.0254903 -0.00299498 0.00226534 -0.0254881 -0.00227427 0.0 +545 2.65 3.55 123.75 0.00105767 0.0250956 -0.00100249 0.00302411 -0.0251043 -0.00302286 0.0 +546 2.65 3.55 131.25 0.00089622 0.018822 -0.000861732 0.00254531 -0.0188028 -0.00256904 0.0 +547 2.65 3.55 138.75 0.00382565 0.0100627 -0.0038702 0.000936262 -0.0101195 -0.000921113 0.0 +548 2.65 3.55 146.25 0.00637878 -0.00112474 -0.0063611 -0.000499545 0.00116119 0.000462636 0.0 +549 2.65 3.55 153.75 0.00342379 -0.0163538 -0.00340327 -0.0001089 0.0163686 9.31942e-05 0.0 +550 2.65 3.55 161.25 -0.0063525 -0.0350349 0.00642576 0.00261085 0.0350954 -0.00266173 0.0 +551 2.65 3.55 168.75 -0.0193118 -0.0529521 0.01932 0.00641632 0.0530167 -0.00647477 0.0 +552 2.65 3.55 176.25 -0.0282729 -0.0640227 0.0283342 0.00913184 0.0640796 -0.00915341 0.0 +553 2.65 3.65 3.75 -9.07399 3.23181 9.07399 31.5979 -3.23181 -31.5979 0.0 +554 2.65 3.65 11.25 -6.54957 2.36668 6.54957 18.1922 -2.36668 -18.1922 0.0 +555 2.65 3.65 18.75 -3.41782 1.35636 3.41782 6.44075 -1.35636 -6.44075 0.0 +556 2.65 3.65 26.25 -1.25794 0.63761 1.25794 1.4388 -0.63761 -1.4388 0.0 +557 2.65 3.65 33.75 -0.314954 0.229217 0.314955 0.252105 -0.229219 -0.252103 0.0 +558 2.65 3.65 41.25 -0.0703285 0.0433984 0.0703295 0.0804037 -0.0433987 -0.080406 0.0 +559 2.65 3.65 48.75 -0.0346923 -0.00594178 0.0346905 0.0178914 0.00594136 -0.0178931 0.0 +560 2.65 3.65 56.25 -0.0178793 -0.00218658 0.0178826 -0.0109585 0.00218474 0.0109613 0.0 +561 2.65 3.65 63.75 -0.00296649 0.00371443 0.00296685 -0.0077863 -0.00371456 0.00778602 0.0 +562 2.65 3.65 71.25 0.00156936 0.00391538 -0.00157049 -0.000554586 -0.00391343 0.000556069 0.0 +563 2.65 3.65 78.75 4.72839e-05 0.00437901 -5.76159e-05 0.000766606 -0.00437852 -0.000767667 0.0 +564 2.65 3.65 86.25 -0.00150151 0.00465743 0.00150145 4.48359e-05 -0.00465746 -4.47759e-05 0.0 +565 2.65 3.65 93.75 -0.00154911 0.0023728 0.00155712 3.94444e-05 -0.00237267 -3.93568e-05 0.0 +566 2.65 3.65 101.25 -0.00102647 -0.00107232 0.0010322 0.000455843 0.00107411 -0.000456348 0.0 +567 2.65 3.65 108.75 -0.000931385 -0.00331098 0.000926423 0.000617065 0.00331642 -0.000619741 0.0 +568 2.65 3.65 116.25 -0.00125989 -0.00405896 0.00125662 0.000489735 0.00405917 -0.000489051 0.0 +569 2.65 3.65 123.75 -0.00119027 -0.00416793 0.00118127 0.00025776 0.00417216 -0.000258364 0.0 +570 2.65 3.65 131.25 2.02558e-06 -0.00385544 9.97877e-07 -5.65576e-05 0.00385538 5.6561e-05 0.0 +571 2.65 3.65 138.75 0.0019471 -0.0027434 -0.00193851 -0.000439961 0.00274576 0.000440451 0.0 +572 2.65 3.65 146.25 0.00340728 -0.000754999 -0.00340313 -0.000680537 0.000762165 0.000677165 0.0 +573 2.65 3.65 153.75 0.00324508 0.00162334 -0.00324525 -0.000497576 -0.00162245 0.000496814 0.0 +574 2.65 3.65 161.25 0.00132741 0.00369896 -0.00132849 0.000164919 -0.00371082 -0.000158918 0.0 +575 2.65 3.65 168.75 -0.00130947 0.00507786 0.00131187 0.00102227 -0.00507988 -0.00102051 0.0 +576 2.65 3.65 176.25 -0.00317672 0.00571563 0.00316942 0.00161776 -0.00571614 -0.00161842 0.0 +577 2.75 2.55 3.75 -646.883 -824.761 646.883 13661.4 824.761 -13661.4 0.0 +578 2.75 2.55 11.25 -376.729 -565.131 376.729 4500.92 565.131 -4500.92 0.0 +579 2.75 2.55 18.75 -160.492 -319.439 160.492 1493.04 319.439 -1493.04 0.0 +580 2.75 2.55 26.25 -43.8362 -150.439 43.8362 427.402 150.439 -427.402 0.0 +581 2.75 2.55 33.75 -1.31067 -57.798 1.31064 92.2844 57.798 -92.2844 0.0 +582 2.75 2.55 41.25 6.00479 -16.8893 -6.00479 12.5367 16.8893 -12.5367 0.0 +583 2.75 2.55 48.75 4.03968 -2.60255 -4.0397 0.399313 2.60257 -0.399325 0.0 +584 2.75 2.55 56.25 2.21549 0.863126 -2.21544 -0.669249 -0.863129 0.669252 0.0 +585 2.75 2.55 63.75 1.40852 0.965831 -1.40854 -0.799145 -0.965837 0.799139 0.0 +586 2.75 2.55 71.25 0.877522 0.581863 -0.877718 -0.688179 -0.58189 0.688182 0.0 +587 2.75 2.55 78.75 0.432572 0.486926 -0.432514 -0.598602 -0.486947 0.598584 0.0 +588 2.75 2.55 86.25 0.163082 0.5836 -0.163134 -0.629205 -0.583719 0.629203 0.0 +589 2.75 2.55 93.75 0.0579151 0.606926 -0.0578918 -0.622595 -0.606869 0.622589 0.0 +590 2.75 2.55 101.25 0.0188255 0.45842 -0.0190481 -0.481734 -0.458384 0.481734 0.0 +591 2.75 2.55 108.75 -0.0159447 0.212618 0.0158542 -0.267236 -0.212519 0.267236 0.0 +592 2.75 2.55 116.25 -0.0341603 -0.00942321 0.0342676 -0.0831169 0.00944397 0.0831394 0.0 +593 2.75 2.55 123.75 0.00214989 -0.134649 -0.00214598 0.0210578 0.134553 -0.0210391 0.0 +594 2.75 2.55 131.25 0.0938516 -0.166277 -0.0938361 0.0622856 0.166334 -0.0623105 0.0 +595 2.75 2.55 138.75 0.18366 -0.166533 -0.183695 0.0899007 0.166491 -0.0898952 0.0 +596 2.75 2.55 146.25 0.192167 -0.212871 -0.19235 0.147586 0.212929 -0.147608 0.0 +597 2.75 2.55 153.75 0.0741489 -0.350932 -0.0741025 0.250625 0.350927 -0.250612 0.0 +598 2.75 2.55 161.25 -0.14589 -0.565391 0.145774 0.382212 0.565381 -0.382217 0.0 +599 2.75 2.55 168.75 -0.383057 -0.786435 0.383012 0.504804 0.786416 -0.504808 0.0 +600 2.75 2.55 176.25 -0.535417 -0.926475 0.535265 0.578566 0.926571 -0.578605 0.0 +601 2.75 2.65 3.75 -831.831 -860.5 831.831 20895.9 860.5 -20895.9 0.0 +602 2.75 2.65 11.25 -475.094 -547.496 475.094 5365.4 547.496 -5365.4 0.0 +603 2.75 2.65 18.75 -211.099 -284.158 211.099 1707.48 284.158 -1707.48 0.0 +604 2.75 2.65 26.25 -68.5394 -118.424 68.5394 479.405 118.424 -479.405 0.0 +605 2.75 2.65 33.75 -13.6757 -38.7319 13.6757 102.918 38.7319 -102.918 0.0 +606 2.75 2.65 41.25 -0.641629 -9.94534 0.641516 15.2464 9.94536 -15.2464 0.0 +607 2.75 2.65 48.75 0.332944 -2.18488 -0.332922 1.85409 2.18487 -1.8541 0.0 +608 2.75 2.65 56.25 0.112165 -0.465651 -0.112096 0.181132 0.46563 -0.181143 0.0 +609 2.75 2.65 63.75 0.17644 -0.0725113 -0.176231 -0.386031 0.0725132 0.386039 0.0 +610 2.75 2.65 71.25 0.181446 0.0079536 -0.181422 -0.450971 -0.0079448 0.450977 0.0 +611 2.75 2.65 78.75 0.1272 0.0562691 -0.126984 -0.35027 -0.0562978 0.350258 0.0 +612 2.75 2.65 86.25 0.131164 0.146678 -0.130971 -0.320782 -0.146689 0.320782 0.0 +613 2.75 2.65 93.75 0.184111 0.220732 -0.184056 -0.310724 -0.220653 0.310723 0.0 +614 2.75 2.65 101.25 0.213605 0.217192 -0.213601 -0.244091 -0.217167 0.244081 0.0 +615 2.75 2.65 108.75 0.179639 0.136558 -0.179737 -0.132731 -0.136657 0.132727 0.0 +616 2.75 2.65 116.25 0.100081 0.0217289 -0.100093 -0.0251836 -0.0217251 0.0251759 0.0 +617 2.75 2.65 123.75 0.0195628 -0.0815694 -0.0193724 0.0480742 0.0816744 -0.0480962 0.0 +618 2.75 2.65 131.25 -0.0392766 -0.157775 0.0391865 0.0897435 0.157642 -0.0896697 0.0 +619 2.75 2.65 138.75 -0.100375 -0.232729 0.100477 0.125775 0.232723 -0.125727 0.0 +620 2.75 2.65 146.25 -0.214623 -0.354582 0.214959 0.184674 0.354626 -0.184677 0.0 +621 2.75 2.65 153.75 -0.413318 -0.55297 0.413289 0.278244 0.552966 -0.278243 0.0 +622 2.75 2.65 161.25 -0.673058 -0.807985 0.672735 0.393846 0.807876 -0.393806 0.0 +623 2.75 2.65 168.75 -0.921828 -1.05215 0.921789 0.500727 1.05224 -0.500783 0.0 +624 2.75 2.65 176.25 -1.07494 -1.20227 1.0747 0.564979 1.20218 -0.564915 0.0 +625 2.75 2.75 3.75 -953.112 -854.306 953.112 25981 854.306 -25981 0.0 +626 2.75 2.75 11.25 -539.051 -520.941 539.051 5855.95 520.941 -5855.95 0.0 +627 2.75 2.75 18.75 -242.983 -254.204 242.983 1824.66 254.204 -1824.66 0.0 +628 2.75 2.75 26.25 -83.2573 -94.4794 83.2573 502.272 94.4793 -502.272 0.0 +629 2.75 2.75 33.75 -20.5412 -24.7823 20.5412 104.828 24.7823 -104.828 0.0 +630 2.75 2.75 41.25 -3.9136 -4.29412 3.91362 14.9464 4.2941 -14.9465 0.0 +631 2.75 2.75 48.75 -1.12328 -0.873619 1.12322 1.93019 0.873624 -1.93018 0.0 +632 2.75 2.75 56.25 -0.514324 -0.496154 0.514312 0.391368 0.496221 -0.39134 0.0 +633 2.75 2.75 63.75 -0.164596 -0.213443 0.164691 -0.208447 0.213484 0.208481 0.0 +634 2.75 2.75 71.25 -0.041967 -0.0485499 0.0420123 -0.328452 0.0485135 0.328445 0.0 +635 2.75 2.75 78.75 0.00770861 0.0144404 -0.0076428 -0.256255 -0.0144125 0.25625 0.0 +636 2.75 2.75 86.25 0.090797 0.0907928 -0.090835 -0.225168 -0.0907865 0.225168 0.0 +637 2.75 2.75 93.75 0.181978 0.179759 -0.182045 -0.218388 -0.179673 0.218388 0.0 +638 2.75 2.75 101.25 0.225859 0.223811 -0.2259 -0.17996 -0.22375 0.17996 0.0 +639 2.75 2.75 108.75 0.197221 0.193022 -0.197213 -0.105534 -0.19316 0.105561 0.0 +640 2.75 2.75 116.25 0.109362 0.103419 -0.109316 -0.0211263 -0.10351 0.0211473 0.0 +641 2.75 2.75 123.75 0.00356169 -0.00337669 -0.00365545 0.0468134 0.00343037 -0.0468135 0.0 +642 2.75 2.75 131.25 -0.0899181 -0.097849 0.0896843 0.0904862 0.0978568 -0.090473 0.0 +643 2.75 2.75 138.75 -0.180752 -0.189165 0.180483 0.124806 0.189251 -0.124873 0.0 +644 2.75 2.75 146.25 -0.307245 -0.315227 0.307006 0.173842 0.315177 -0.173832 0.0 +645 2.75 2.75 153.75 -0.495888 -0.504071 0.495883 0.250885 0.504047 -0.250882 0.0 +646 2.75 2.75 161.25 -0.730452 -0.740638 0.730449 0.347741 0.740677 -0.347784 0.0 +647 2.75 2.75 168.75 -0.951281 -0.965256 0.9512 0.438629 0.965085 -0.438584 0.0 +648 2.75 2.75 176.25 -1.08583 -1.10279 1.08592 0.493743 1.10285 -0.493793 0.0 +649 2.75 2.85 3.75 -970.563 -775.744 970.563 23153.2 775.744 -23153.2 0.0 +650 2.75 2.85 11.25 -556.721 -474.097 556.721 5862.74 474.097 -5862.74 0.0 +651 2.75 2.85 18.75 -250.751 -224.584 250.751 1827.2 224.584 -1827.2 0.0 +652 2.75 2.85 26.25 -86.059 -77.5526 86.059 494.052 77.5526 -494.052 0.0 +653 2.75 2.85 33.75 -21.7848 -16.8577 21.7848 99.2767 16.8577 -99.2767 0.0 +654 2.75 2.85 41.25 -4.50961 -1.52272 4.5095 12.9376 1.52274 -12.9376 0.0 +655 2.75 2.85 48.75 -1.25065 -0.243785 1.25071 1.39261 0.243763 -1.39263 0.0 +656 2.75 2.85 56.25 -0.463066 -0.460087 0.463015 0.300113 0.460075 -0.300136 0.0 +657 2.75 2.85 63.75 -0.151187 -0.275288 0.151132 -0.144808 0.275348 0.144857 0.0 +658 2.75 2.85 71.25 -0.0749749 -0.110892 0.0749169 -0.249281 0.110829 0.249264 0.0 +659 2.75 2.85 78.75 -0.0201116 -0.0351113 0.0202283 -0.210984 0.0351362 0.210976 0.0 +660 2.75 2.85 86.25 0.0736389 0.0501401 -0.0736054 -0.194737 -0.0502144 0.194733 0.0 +661 2.75 2.85 93.75 0.160078 0.146192 -0.159898 -0.1879 -0.146241 0.187904 0.0 +662 2.75 2.85 101.25 0.200786 0.204303 -0.200728 -0.156391 -0.204259 0.156374 0.0 +663 2.75 2.85 108.75 0.17997 0.193028 -0.179585 -0.0955768 -0.192919 0.0955569 0.0 +664 2.75 2.85 116.25 0.103624 0.119278 -0.103941 -0.0221991 -0.119219 0.0221951 0.0 +665 2.75 2.85 123.75 0.00644177 0.0211333 -0.00659697 0.0394802 -0.0210367 -0.0394978 0.0 +666 2.75 2.85 131.25 -0.0803186 -0.0672129 0.080414 0.0781492 0.0671178 -0.0781413 0.0 +667 2.75 2.85 138.75 -0.161637 -0.148838 0.161505 0.105436 0.149111 -0.105534 0.0 +668 2.75 2.85 146.25 -0.270086 -0.257695 0.270083 0.14428 0.257823 -0.144344 0.0 +669 2.75 2.85 153.75 -0.43239 -0.421507 0.432363 0.208547 0.421587 -0.208591 0.0 +670 2.75 2.85 161.25 -0.634898 -0.628455 0.634872 0.291785 0.628448 -0.291789 0.0 +671 2.75 2.85 168.75 -0.826247 -0.825693 0.826352 0.370982 0.825733 -0.37098 0.0 +672 2.75 2.85 176.25 -0.943351 -0.946865 0.943117 0.419282 0.946914 -0.419356 0.0 +673 2.75 2.95 3.75 -897.538 -636.356 897.538 17274.5 636.356 -17274.5 0.0 +674 2.75 2.95 11.25 -527.594 -400.007 527.594 5426.93 400.007 -5426.93 0.0 +675 2.75 2.95 18.75 -234.856 -188.606 234.856 1719.6 188.606 -1719.6 0.0 +676 2.75 2.95 26.25 -78.0109 -63.1924 78.0109 457.632 63.1924 -457.632 0.0 +677 2.75 2.95 33.75 -18.5523 -12.6415 18.5523 88.2261 12.6415 -88.2261 0.0 +678 2.75 2.95 41.25 -3.43241 -0.788747 3.43237 10.3311 0.788758 -10.3311 0.0 +679 2.75 2.95 48.75 -0.834456 -0.199558 0.834517 0.799118 0.199613 -0.799125 0.0 +680 2.75 2.95 56.25 -0.273778 -0.463123 0.273749 0.148104 0.463143 -0.148167 0.0 +681 2.75 2.95 63.75 -0.103413 -0.318818 0.103504 -0.111608 0.31885 0.111645 0.0 +682 2.75 2.95 71.25 -0.0843263 -0.181793 0.0843793 -0.175312 0.181809 0.175287 0.0 +683 2.75 2.95 78.75 -0.0303993 -0.093494 0.0304044 -0.167209 0.0935528 0.167232 0.0 +684 2.75 2.95 86.25 0.0620423 0.00699782 -0.0622995 -0.169543 -0.00683051 0.169553 0.0 +685 2.75 2.95 93.75 0.136614 0.106217 -0.136678 -0.163514 -0.106191 0.163506 0.0 +686 2.75 2.95 101.25 0.17196 0.170249 -0.171903 -0.134812 -0.170364 0.13483 0.0 +687 2.75 2.95 108.75 0.15684 0.174342 -0.156924 -0.0828548 -0.174193 0.082802 0.0 +688 2.75 2.95 116.25 0.0926482 0.118695 -0.0927901 -0.0195911 -0.118646 0.0195826 0.0 +689 2.75 2.95 123.75 0.00849675 0.0355959 -0.00833828 0.0336514 -0.0356652 -0.0336479 0.0 +690 2.75 2.95 131.25 -0.0660839 -0.0418908 0.0662238 0.0659291 0.041797 -0.065883 0.0 +691 2.75 2.95 138.75 -0.134275 -0.114174 0.134106 0.0880437 0.114322 -0.0880806 0.0 +692 2.75 2.95 146.25 -0.227305 -0.21177 0.227027 0.121094 0.2116 -0.121002 0.0 +693 2.75 2.95 153.75 -0.368554 -0.358527 0.368374 0.177219 0.358663 -0.177335 0.0 +694 2.75 2.95 161.25 -0.546482 -0.542986 0.546711 0.250148 0.542877 -0.250051 0.0 +695 2.75 2.95 168.75 -0.715439 -0.717898 0.715379 0.319323 0.717937 -0.319304 0.0 +696 2.75 2.95 176.25 -0.817997 -0.824689 0.818295 0.361371 0.825027 -0.361574 0.0 +697 2.75 3.05 3.75 -770.161 -463.434 770.161 12393.7 463.434 -12393.7 0.0 +698 2.75 3.05 11.25 -462.237 -301.474 462.237 4693.99 301.474 -4693.99 0.0 +699 2.75 3.05 18.75 -201.495 -143.479 201.495 1525.17 143.479 -1525.17 0.0 +700 2.75 3.05 26.25 -62.9238 -47.8688 62.9238 399.794 47.8688 -399.794 0.0 +701 2.75 3.05 33.75 -12.9682 -9.61891 12.9682 73.8547 9.61892 -73.8547 0.0 +702 2.75 3.05 41.25 -1.7583 -0.85457 1.75829 7.81837 0.854518 -7.81834 0.0 +703 2.75 3.05 48.75 -0.381642 -0.346117 0.381587 0.40516 0.34605 -0.405176 0.0 +704 2.75 3.05 56.25 -0.163641 -0.440252 0.163583 0.0381865 0.440156 -0.0381959 0.0 +705 2.75 3.05 63.75 -0.103568 -0.332346 0.103485 -0.0833787 0.332372 0.0833554 0.0 +706 2.75 3.05 71.25 -0.101444 -0.24461 0.101602 -0.107568 0.244525 0.107546 0.0 +707 2.75 3.05 78.75 -0.038508 -0.1504 0.038783 -0.1224 0.150253 0.122395 0.0 +708 2.75 3.05 86.25 0.0496984 -0.0343332 -0.0494439 -0.140095 0.0345932 0.140101 0.0 +709 2.75 3.05 93.75 0.111297 0.06995 -0.111612 -0.135869 -0.0701637 0.135882 0.0 +710 2.75 3.05 101.25 0.140426 0.140943 -0.140275 -0.110396 -0.140778 0.110407 0.0 +711 2.75 3.05 108.75 0.12795 0.158778 -0.128322 -0.0664922 -0.158818 0.0664985 0.0 +712 2.75 3.05 116.25 0.0728381 0.119891 -0.0730793 -0.0130873 -0.11982 0.0129934 0.0 +713 2.75 3.05 123.75 0.000267345 0.0511317 -9.01598e-05 0.0314953 -0.0510922 -0.03149 0.0 +714 2.75 3.05 131.25 -0.063069 -0.0174406 0.0628665 0.0580034 0.0170276 -0.0579042 0.0 +715 2.75 3.05 138.75 -0.119018 -0.0842153 0.11903 0.0763319 0.0841315 -0.0762935 0.0 +716 2.75 3.05 146.25 -0.197865 -0.1752 0.197467 0.104414 0.175196 -0.104295 0.0 +717 2.75 3.05 153.75 -0.319615 -0.309756 0.319424 0.151665 0.309809 -0.15167 0.0 +718 2.75 3.05 161.25 -0.473103 -0.474577 0.47295 0.212121 0.474601 -0.212138 0.0 +719 2.75 3.05 168.75 -0.617392 -0.628077 0.617611 0.268756 0.627819 -0.268631 0.0 +720 2.75 3.05 176.25 -0.705354 -0.720636 0.705297 0.302934 0.720794 -0.303013 0.0 +721 2.75 3.15 3.75 -621.059 -283.307 621.059 8818.58 283.307 -8818.58 0.0 +722 2.75 3.15 11.25 -378.076 -190.869 378.076 3830.09 190.869 -3830.09 0.0 +723 2.75 3.15 18.75 -160.427 -92.3481 160.427 1277.7 92.3481 -1277.7 0.0 +724 2.75 3.15 26.25 -45.9966 -30.9532 45.9966 329.373 30.9532 -329.373 0.0 +725 2.75 3.15 33.75 -7.4094 -6.49374 7.40945 58.1344 6.49371 -58.1344 0.0 +726 2.75 3.15 41.25 -0.360268 -0.948504 0.360207 5.64912 0.948525 -5.64911 0.0 +727 2.75 3.15 48.75 -0.109681 -0.454359 0.109583 0.215632 0.454311 -0.215651 0.0 +728 2.75 3.15 56.25 -0.128581 -0.381055 0.12849 -0.024614 0.380998 0.0245607 0.0 +729 2.75 3.15 63.75 -0.107772 -0.325095 0.107852 -0.0656164 0.325178 0.0656213 0.0 +730 2.75 3.15 71.25 -0.10009 -0.293719 0.100061 -0.059479 0.293753 0.059475 0.0 +731 2.75 3.15 78.75 -0.036158 -0.200438 0.0358502 -0.0856231 0.200546 0.0856524 0.0 +732 2.75 3.15 86.25 0.0377439 -0.0742392 -0.037571 -0.109183 0.0742289 0.109172 0.0 +733 2.75 3.15 93.75 0.0838315 0.0343987 -0.0838656 -0.104987 -0.0344864 0.105012 0.0 +734 2.75 3.15 101.25 0.106057 0.110494 -0.106108 -0.0834801 -0.110598 0.0834927 0.0 +735 2.75 3.15 108.75 0.0968552 0.139813 -0.0967877 -0.0483794 -0.139765 0.0483448 0.0 +736 2.75 3.15 116.25 0.051391 0.115917 -0.0515763 -0.0060004 -0.116112 0.00610288 0.0 +737 2.75 3.15 123.75 -0.00713598 0.0613642 0.00718246 0.0286098 -0.0614779 -0.0285439 0.0 +738 2.75 3.15 131.25 -0.0559847 0.00396885 0.0560961 0.0483465 -0.00390007 -0.0484359 0.0 +739 2.75 3.15 138.75 -0.0990609 -0.0545791 0.0984659 0.061732 0.0548182 -0.0618343 0.0 +740 2.75 3.15 146.25 -0.159454 -0.134936 0.1595 0.0827794 0.135061 -0.08272 0.0 +741 2.75 3.15 153.75 -0.25524 -0.251075 0.255086 0.118141 0.251122 -0.118172 0.0 +742 2.75 3.15 161.25 -0.375288 -0.38964 0.375663 0.162894 0.389747 -0.16293 0.0 +743 2.75 3.15 168.75 -0.488486 -0.516392 0.488643 0.204424 0.516148 -0.204273 0.0 +744 2.75 3.15 176.25 -0.556839 -0.591689 0.556911 0.229329 0.591767 -0.229304 0.0 +745 2.75 3.25 3.75 -476.667 -121.19 476.667 6210.58 121.19 -6210.58 0.0 +746 2.75 3.25 11.25 -293.373 -85.8334 293.373 2968.1 85.8334 -2968.1 0.0 +747 2.75 3.25 18.75 -121.508 -42.7495 121.508 1012.27 42.7495 -1012.27 0.0 +748 2.75 3.25 26.25 -31.8786 -14.325 31.8786 255.334 14.325 -255.334 0.0 +749 2.75 3.25 33.75 -3.63288 -3.16546 3.63301 42.6516 3.16544 -42.6516 0.0 +750 2.75 3.25 41.25 0.315726 -0.793557 -0.315791 3.80727 0.79365 -3.8073 0.0 +751 2.75 3.25 48.75 -0.0242544 -0.460584 0.0242178 0.130581 0.460619 -0.130536 0.0 +752 2.75 3.25 56.25 -0.0991531 -0.30838 0.0992679 -0.0606306 0.308269 0.0605918 0.0 +753 2.75 3.25 63.75 -0.0775749 -0.303078 0.0775341 -0.058713 0.303134 0.0587059 0.0 +754 2.75 3.25 71.25 -0.0726081 -0.316404 0.0725509 -0.0320203 0.316355 0.0321083 0.0 +755 2.75 3.25 78.75 -0.0250871 -0.232854 0.0249036 -0.0576022 0.232759 0.0576201 0.0 +756 2.75 3.25 86.25 0.0262879 -0.108161 -0.0264355 -0.0771184 0.108011 0.0771155 0.0 +757 2.75 3.25 93.75 0.0560476 -0.000207024 -0.0559883 -0.0716051 0.000146475 0.0716155 0.0 +758 2.75 3.25 101.25 0.072468 0.0806321 -0.0723149 -0.0559611 -0.0805163 0.0559016 0.0 +759 2.75 3.25 108.75 0.0683282 0.121003 -0.068317 -0.0319853 -0.121 0.0319423 0.0 +760 2.75 3.25 116.25 0.0376756 0.112607 -0.037291 -0.00283035 -0.112703 0.00284452 0.0 +761 2.75 3.25 123.75 -0.00470402 0.0730337 0.00443815 0.0205484 -0.072994 -0.0206443 0.0 +762 2.75 3.25 131.25 -0.0393657 0.0275953 0.0393646 0.0333389 -0.02763 -0.0332308 0.0 +763 2.75 3.25 138.75 -0.0690594 -0.0208708 0.0692442 0.0419952 0.0207699 -0.0419967 0.0 +764 2.75 3.25 146.25 -0.111014 -0.0862657 0.110952 0.0560987 0.0863438 -0.0561322 0.0 +765 2.75 3.25 153.75 -0.176809 -0.178443 0.176496 0.0798216 0.178512 -0.0798746 0.0 +766 2.75 3.25 161.25 -0.258767 -0.286055 0.259122 0.109635 0.286421 -0.109773 0.0 +767 2.75 3.25 168.75 -0.336709 -0.383242 0.3365 0.137155 0.383371 -0.137249 0.0 +768 2.75 3.25 176.25 -0.383233 -0.440518 0.383304 0.153612 0.440294 -0.153402 0.0 +769 2.75 3.35 3.75 -341.385 1.74756 341.385 4134.74 -1.74757 -4134.74 0.0 +770 2.75 3.35 11.25 -213.168 -3.19693 213.168 2109.24 3.19691 -2109.24 0.0 +771 2.75 3.35 18.75 -87.8275 -2.99417 87.8276 729.622 2.99416 -729.622 0.0 +772 2.75 3.35 26.25 -22.0888 -0.704944 22.0887 178.369 0.70499 -178.369 0.0 +773 2.75 3.35 33.75 -2.07542 -0.0682655 2.0755 27.6089 0.0682662 -27.6089 0.0 +774 2.75 3.35 41.25 0.300247 -0.350456 -0.300305 2.18926 0.350473 -2.18927 0.0 +775 2.75 3.35 48.75 -0.0373785 -0.369541 0.0374118 0.0833796 0.36958 -0.083402 0.0 +776 2.75 3.35 56.25 -0.0518069 -0.259322 0.0517312 -0.0686295 0.259412 0.0687251 0.0 +777 2.75 3.35 63.75 -0.0322367 -0.285586 0.0323754 -0.0471277 0.285461 0.0471608 0.0 +778 2.75 3.35 71.25 -0.0437375 -0.317171 0.043788 -0.0133265 0.317084 0.0133532 0.0 +779 2.75 3.35 78.75 -0.0172441 -0.248737 0.0171536 -0.0330689 0.248747 0.0330618 0.0 +780 2.75 3.35 86.25 0.0144849 -0.135178 -0.014571 -0.0452186 0.135353 0.0452189 0.0 +781 2.75 3.35 93.75 0.030471 -0.0300865 -0.030347 -0.0398041 0.0300945 0.0397911 0.0 +782 2.75 3.35 101.25 0.0406014 0.0563913 -0.0407253 -0.0312837 -0.0564639 0.0312859 0.0 +783 2.75 3.35 108.75 0.0422766 0.108893 -0.0423538 -0.0189637 -0.109138 0.0190212 0.0 +784 2.75 3.35 116.25 0.0267588 0.115186 -0.0269597 -0.00297617 -0.11525 0.00295127 0.0 +785 2.75 3.35 123.75 0.000501099 0.0878862 -0.000774694 0.0104498 -0.0881349 -0.0102325 0.0 +786 2.75 3.35 131.25 -0.0236225 0.0489236 0.0238085 0.0185255 -0.0490552 -0.0184822 0.0 +787 2.75 3.35 138.75 -0.0444452 0.00629968 0.044223 0.0246731 -0.00652667 -0.0245664 0.0 +788 2.75 3.35 146.25 -0.0693381 -0.0474412 0.069485 0.0339103 0.0474594 -0.0339419 0.0 +789 2.75 3.35 153.75 -0.107186 -0.118947 0.107138 0.0484857 0.1189 -0.0484203 0.0 +790 2.75 3.35 161.25 -0.154793 -0.200912 0.154723 0.0665572 0.200588 -0.0663788 0.0 +791 2.75 3.35 168.75 -0.200583 -0.274251 0.200264 0.0833152 0.274149 -0.0833102 0.0 +792 2.75 3.35 176.25 -0.22795 -0.317539 0.228214 0.0934114 0.317615 -0.093522 0.0 +793 2.75 3.45 3.75 -181.602 50.4515 181.602 2007.55 -50.4515 -2007.55 0.0 +794 2.75 3.45 11.25 -116.135 31.353 116.135 1069.23 -31.3531 -1069.23 0.0 +795 2.75 3.45 18.75 -49.1544 14.1197 49.1544 371.433 -14.1197 -371.433 0.0 +796 2.75 3.45 26.25 -12.9027 5.27843 12.9027 86.871 -5.27842 -86.871 0.0 +797 2.75 3.45 33.75 -1.53044 1.58922 1.53042 12.1098 -1.58919 -12.1098 0.0 +798 2.75 3.45 41.25 0.0034182 0.175305 -0.00341175 0.852259 -0.175314 -0.852262 0.0 +799 2.75 3.45 48.75 -0.0627082 -0.187051 0.0626463 0.0745378 0.187162 -0.0745079 0.0 +800 2.75 3.45 56.25 -0.0269175 -0.208615 0.0269865 -0.0380544 0.208565 0.0380413 0.0 +801 2.75 3.45 63.75 -0.0156683 -0.232533 0.0156754 -0.0230666 0.232476 0.0230535 0.0 +802 2.75 3.45 71.25 -0.027083 -0.247837 0.027041 5.30776e-05 0.247723 -0.000124963 0.0 +803 2.75 3.45 78.75 -0.0110419 -0.199747 0.0110237 -0.01275 0.199733 0.0127249 0.0 +804 2.75 3.45 86.25 0.00600723 -0.118375 -0.00584057 -0.01943 0.118327 0.0194294 0.0 +805 2.75 3.45 93.75 0.00873478 -0.0394094 -0.00879205 -0.0152652 0.0394659 0.0152585 0.0 +806 2.75 3.45 101.25 0.00962037 0.0272073 -0.00960224 -0.0103152 -0.0271381 0.0103031 0.0 +807 2.75 3.45 108.75 0.0122306 0.0719369 -0.0122886 -0.00545491 -0.071926 0.00547195 0.0 +808 2.75 3.45 116.25 0.00974245 0.0846866 -0.00979763 -2.00295e-05 -0.084746 5.2625e-05 0.0 +809 2.75 3.45 123.75 0.000243929 0.070346 -0.000352399 0.00484904 -0.0702929 -0.00489636 0.0 +810 2.75 3.45 131.25 -0.010453 0.043801 0.0102586 0.00831848 -0.0439736 -0.00824598 0.0 +811 2.75 3.45 138.75 -0.0180464 0.0137037 0.0179837 0.0107806 -0.0137201 -0.0108167 0.0 +812 2.75 3.45 146.25 -0.025475 -0.0218772 0.0256088 0.0136926 0.0220646 -0.0138449 0.0 +813 2.75 3.45 153.75 -0.0382383 -0.0672046 0.0382092 0.0186021 0.0672579 -0.018626 0.0 +814 2.75 3.45 161.25 -0.0575259 -0.119353 0.0574959 0.0256839 0.119252 -0.0256513 0.0 +815 2.75 3.45 168.75 -0.0781428 -0.166869 0.078149 0.0330717 0.16689 -0.0331148 0.0 +816 2.75 3.45 176.25 -0.0916728 -0.195518 0.0917779 0.0378401 0.195665 -0.037981 0.0 +817 2.75 3.55 3.75 -60.5153 27.692 60.5153 588.046 -27.692 -588.046 0.0 +818 2.75 3.55 11.25 -39.8784 17.4201 39.8784 321.892 -17.4201 -321.892 0.0 +819 2.75 3.55 18.75 -17.6334 7.7718 17.6334 111.365 -7.7718 -111.365 0.0 +820 2.75 3.55 26.25 -4.94614 2.91047 4.94616 24.801 -2.91047 -24.801 0.0 +821 2.75 3.55 33.75 -0.717862 1.02613 0.717872 3.21211 -1.02616 -3.21209 0.0 +822 2.75 3.55 41.25 -0.0703286 0.253386 0.0703577 0.326292 -0.253389 -0.326305 0.0 +823 2.75 3.55 48.75 -0.0696314 -0.0360868 0.0696098 0.0745468 0.0361057 -0.0745544 0.0 +824 2.75 3.55 56.25 -0.0386849 -0.0894109 0.0386635 -0.0191097 0.0894516 0.0190794 0.0 +825 2.75 3.55 63.75 -0.0158765 -0.0925221 0.0158458 -0.0145167 0.09256 0.0145237 0.0 +826 2.75 3.55 71.25 -0.00997075 -0.0929607 0.00998059 0.000467248 0.0929809 -0.000443377 0.0 +827 2.75 3.55 78.75 -0.00149974 -0.0734939 0.00146198 -0.00355586 0.0735358 0.00355353 0.0 +828 2.75 3.55 86.25 0.0028805 -0.042718 -0.00289025 -0.00634796 0.0427423 0.00634686 0.0 +829 2.75 3.55 93.75 -0.000895397 -0.0173398 0.000915914 -0.00268197 0.0173692 0.00268557 0.0 +830 2.75 3.55 101.25 -0.00461455 0.00200332 0.00464936 0.00177679 -0.00195006 -0.0017874 0.0 +831 2.75 3.55 108.75 -0.00367123 0.0176377 0.00372332 0.00363241 -0.0176972 -0.00361264 0.0 +832 2.75 3.55 116.25 -0.00131124 0.0260317 0.00133193 0.00346321 -0.0260021 -0.00346733 0.0 +833 2.75 3.55 123.75 -0.000257145 0.0251737 0.000204938 0.00292588 -0.0251838 -0.00291469 0.0 +834 2.75 3.55 131.25 0.000973531 0.0188626 -0.000971992 0.00228745 -0.0188196 -0.00232812 0.0 +835 2.75 3.55 138.75 0.00409367 0.011615 -0.00404917 0.000911448 -0.011591 -0.000925473 0.0 +836 2.75 3.55 146.25 0.00744491 0.00348645 -0.0075166 -0.000905243 -0.00344952 0.000869305 0.0 +837 2.75 3.55 153.75 0.00762023 -0.00783196 -0.00763712 -0.00180907 0.00784858 0.00180265 0.0 +838 2.75 3.55 161.25 0.00271034 -0.0229315 -0.00264761 -0.000890015 0.0229401 0.000888095 0.0 +839 2.75 3.55 168.75 -0.0051415 -0.0382675 0.00514139 0.00125874 0.0383533 -0.00131918 0.0 +840 2.75 3.55 176.25 -0.0109249 -0.0480268 0.0109626 0.00300256 0.0480665 -0.00301775 0.0 +841 2.75 3.65 3.75 -5.4585 2.19054 5.4585 46.1523 -2.19054 -46.1523 0.0 +842 2.75 3.65 11.25 -3.66097 1.22096 3.66097 25.7483 -1.22096 -25.7483 0.0 +843 2.75 3.65 18.75 -1.63156 0.409151 1.63156 8.91799 -0.409152 -8.91799 0.0 +844 2.75 3.65 26.25 -0.435259 0.123143 0.435261 1.99397 -0.123144 -1.99397 0.0 +845 2.75 3.65 33.75 -0.0493642 0.0652704 0.0493648 0.328683 -0.0652688 -0.328684 0.0 +846 2.75 3.65 41.25 -0.0146925 0.0282769 0.0146967 0.0813637 -0.0282736 -0.0813666 0.0 +847 2.75 3.65 48.75 -0.0246544 0.00490522 0.0246565 0.0166878 -0.00490432 -0.0166888 0.0 +848 2.75 3.65 56.25 -0.0139125 0.00395284 0.0139089 -0.00867723 -0.00395188 0.00867599 0.0 +849 2.75 3.65 63.75 -0.00270241 0.00619066 0.00270068 -0.00571762 -0.00619525 0.00571944 0.0 +850 2.75 3.65 71.25 0.000519918 0.00471435 -0.000521654 -8.15984e-06 -0.00471422 7.2579e-06 0.0 +851 2.75 3.65 78.75 0.000501459 0.00398609 -0.00050026 0.000797399 -0.00398918 -0.000797502 0.0 +852 2.75 3.65 86.25 -4.4671e-05 0.00352149 4.27284e-05 0.000514162 -0.00352011 -0.000514185 0.0 +853 2.75 3.65 93.75 -0.000889969 0.00110883 0.000890202 0.00115235 -0.00110879 -0.00115223 0.0 +854 2.75 3.65 101.25 -0.00151239 -0.00165277 0.00151236 0.00181475 0.00164834 -0.00181365 0.0 +855 2.75 3.65 108.75 -0.00161992 -0.00273717 0.00161755 0.00169929 0.00273792 -0.00169984 0.0 +856 2.75 3.65 116.25 -0.00158692 -0.00271981 0.00158207 0.00119301 0.00272293 -0.00119423 0.0 +857 2.75 3.65 123.75 -0.00161004 -0.0028994 0.00160522 0.000901196 0.00289974 -0.000900406 0.0 +858 2.75 3.65 131.25 -0.00135618 -0.00318701 0.00134929 0.000817217 0.00318514 -0.000815958 0.0 +859 2.75 3.65 138.75 -0.000562397 -0.00258908 0.000562926 0.000632375 0.00259618 -0.000635132 0.0 +860 2.75 3.65 146.25 0.000398525 -0.000673377 -0.000405592 0.000326015 0.000673344 -0.000326095 0.0 +861 2.75 3.65 153.75 0.000850024 0.00202598 -0.000855047 0.000185369 -0.00202081 -0.000188642 0.0 +862 2.75 3.65 161.25 0.000434663 0.00458686 -0.000435573 0.000417059 -0.00458533 -0.000417937 0.0 +863 2.75 3.65 168.75 -0.000552814 0.00638533 0.000542524 0.000898487 -0.00637922 -0.0009015 0.0 +864 2.75 3.65 176.25 -0.00133582 0.00725755 0.00133015 0.00128127 -0.0072543 -0.00128197 0.0 +865 2.85 2.55 3.75 -449.454 -941.562 449.454 9549.73 941.562 -9549.73 0.0 +866 2.85 2.55 11.25 -203.687 -668.13 203.687 3736.46 668.13 -3736.46 0.0 +867 2.85 2.55 18.75 -12.9246 -383.103 12.9246 1213.6 383.103 -1213.6 0.0 +868 2.85 2.55 26.25 63.1921 -179.462 -63.1921 299.966 179.462 -299.966 0.0 +869 2.85 2.55 33.75 62.6546 -65.7116 -62.6546 36.4372 65.7116 -36.4372 0.0 +870 2.85 2.55 41.25 37.3635 -15.6969 -37.3635 -9.14011 15.6969 9.14011 0.0 +871 2.85 2.55 48.75 16.895 0.618772 -16.8951 -7.08679 -0.618757 7.08678 0.0 +872 2.85 2.55 56.25 6.97832 3.39374 -6.97835 -3.15346 -3.39374 3.15347 0.0 +873 2.85 2.55 63.75 3.27315 2.52802 -3.27315 -1.83047 -2.52803 1.83048 0.0 +874 2.85 2.55 71.25 1.70047 1.62582 -1.70071 -1.50656 -1.62582 1.50656 0.0 +875 2.85 2.55 78.75 0.749832 1.27937 -0.749875 -1.51872 -1.27941 1.51871 0.0 +876 2.85 2.55 86.25 0.164393 1.07494 -0.164439 -1.55346 -1.07491 1.55346 0.0 +877 2.85 2.55 93.75 -0.138619 0.673196 0.138741 -1.36215 -0.67314 1.36215 0.0 +878 2.85 2.55 101.25 -0.256642 0.101433 0.256803 -0.949432 -0.10153 0.949443 0.0 +879 2.85 2.55 108.75 -0.221358 -0.430558 0.221453 -0.50286 0.43059 0.502868 0.0 +880 2.85 2.55 116.25 -0.00716267 -0.763914 0.00707724 -0.182642 0.763996 0.182594 0.0 +881 2.85 2.55 123.75 0.389318 -0.868932 -0.38922 -0.0254116 0.869042 0.0254047 0.0 +882 2.85 2.55 131.25 0.89597 -0.814762 -0.896002 0.0246925 0.814838 -0.0247272 0.0 +883 2.85 2.55 138.75 1.38115 -0.710613 -1.3812 0.0482113 0.710584 -0.0481961 0.0 +884 2.85 2.55 146.25 1.7166 -0.656942 -1.71663 0.102514 0.657017 -0.102563 0.0 +885 2.85 2.55 153.75 1.84068 -0.706888 -1.84082 0.204441 0.706832 -0.204425 0.0 +886 2.85 2.55 161.25 1.78401 -0.848447 -1.78392 0.335056 0.848436 -0.335074 0.0 +887 2.85 2.55 168.75 1.64517 -1.0163 -1.64523 0.455943 1.01631 -0.455929 0.0 +888 2.85 2.55 176.25 1.53852 -1.12802 -1.53859 0.528256 1.12801 -0.528249 0.0 +889 2.85 2.65 3.75 -736.234 -953.145 736.234 15002.2 953.145 -15002.2 0.0 +890 2.85 2.65 11.25 -383.861 -632.529 383.861 4732.78 632.529 -4732.78 0.0 +891 2.85 2.65 18.75 -120.397 -336.411 120.397 1474.26 336.411 -1474.26 0.0 +892 2.85 2.65 26.25 1.63758 -143.419 -1.63759 371.726 143.419 -371.726 0.0 +893 2.85 2.65 33.75 28.1679 -47.6669 -28.1678 57.9974 47.6669 -57.9974 0.0 +894 2.85 2.65 41.25 18.5052 -11.7053 -18.5053 -0.0411589 11.7053 0.0411506 0.0 +895 2.85 2.65 48.75 6.98344 -1.71526 -6.98349 -2.25925 1.71528 2.25926 0.0 +896 2.85 2.65 56.25 1.90515 0.189804 -1.9051 -0.694423 -0.189827 0.694421 0.0 +897 2.85 2.65 63.75 0.644706 0.289163 -0.644765 -0.553254 -0.289196 0.553251 0.0 +898 2.85 2.65 71.25 0.358032 0.188047 -0.358068 -0.577658 -0.187995 0.577686 0.0 +899 2.85 2.65 78.75 0.193029 0.186045 -0.193065 -0.576896 -0.186053 0.576887 0.0 +900 2.85 2.65 86.25 0.118081 0.206903 -0.117948 -0.590427 -0.206951 0.590426 0.0 +901 2.85 2.65 93.75 0.116313 0.137487 -0.116341 -0.523115 -0.137426 0.523116 0.0 +902 2.85 2.65 101.25 0.127124 -0.0206052 -0.127264 -0.356029 0.020677 0.356027 0.0 +903 2.85 2.65 108.75 0.134169 -0.192715 -0.134356 -0.167112 0.192721 0.16712 0.0 +904 2.85 2.65 116.25 0.166274 -0.317368 -0.166229 -0.0278194 0.317368 0.02781 0.0 +905 2.85 2.65 123.75 0.250031 -0.376343 -0.250195 0.044687 0.376311 -0.0446765 0.0 +906 2.85 2.65 131.25 0.37155 -0.389541 -0.371651 0.0749583 0.389552 -0.0749598 0.0 +907 2.85 2.65 138.75 0.472028 -0.404165 -0.471849 0.101639 0.404085 -0.101599 0.0 +908 2.85 2.65 146.25 0.482744 -0.473853 -0.482714 0.154822 0.473671 -0.154746 0.0 +909 2.85 2.65 153.75 0.372903 -0.626739 -0.372891 0.24309 0.626702 -0.24306 0.0 +910 2.85 2.65 161.25 0.172204 -0.842652 -0.172283 0.351704 0.842593 -0.351702 0.0 +911 2.85 2.65 168.75 -0.0401177 -1.05637 0.0403128 0.45108 1.05642 -0.451106 0.0 +912 2.85 2.65 176.25 -0.17528 -1.18958 0.175428 0.510384 1.18961 -0.5104 0.0 +913 2.85 2.75 3.75 -979.272 -927.69 979.272 22134.5 927.69 -22134.5 0.0 +914 2.85 2.75 11.25 -526.991 -579.811 526.991 5507.99 579.811 -5507.99 0.0 +915 2.85 2.75 18.75 -204.787 -287.701 204.787 1660.86 287.701 -1660.86 0.0 +916 2.85 2.75 26.25 -45.4274 -109.617 45.4273 419.099 109.617 -419.099 0.0 +917 2.85 2.75 33.75 3.4094 -30.3253 -3.40934 70.6375 30.3253 -70.6375 0.0 +918 2.85 2.75 41.25 6.54385 -5.89301 -6.54392 4.65436 5.89304 -4.65435 0.0 +919 2.85 2.75 48.75 1.87015 -1.12692 -1.87015 -0.0807475 1.12691 0.0807413 0.0 +920 2.85 2.75 56.25 -0.0855468 -0.433007 0.085563 0.253215 0.433018 -0.253203 0.0 +921 2.85 2.75 63.75 -0.193076 -0.180261 0.193218 -0.116602 0.180287 0.11663 0.0 +922 2.85 2.75 71.25 -0.0627372 -0.0669432 0.0628705 -0.266699 0.0669458 0.266713 0.0 +923 2.85 2.75 78.75 -0.00113364 -0.000718484 0.00128081 -0.256413 0.000816792 0.25642 0.0 +924 2.85 2.75 86.25 0.0719457 0.0756041 -0.0719355 -0.25934 -0.0756465 0.25934 0.0 +925 2.85 2.75 93.75 0.150932 0.126391 -0.150887 -0.242532 -0.126415 0.242533 0.0 +926 2.85 2.75 101.25 0.19142 0.122864 -0.191283 -0.177304 -0.122828 0.177291 0.0 +927 2.85 2.75 108.75 0.179151 0.072715 -0.179217 -0.0881976 -0.0726424 0.0881763 0.0 +928 2.85 2.75 116.25 0.132856 -0.00182507 -0.132993 -0.00716005 0.00182425 0.0071526 0.0 +929 2.85 2.75 123.75 0.0849914 -0.0757887 -0.0849411 0.0491728 0.0758462 -0.0491697 0.0 +930 2.85 2.75 131.25 0.0493045 -0.137104 -0.0494332 0.0829233 0.137118 -0.0829226 0.0 +931 2.85 2.75 138.75 0.00591187 -0.201372 -0.00575361 0.111436 0.201482 -0.11145 0.0 +932 2.85 2.75 146.25 -0.0859415 -0.304683 0.0860687 0.155414 0.304665 -0.155395 0.0 +933 2.85 2.75 153.75 -0.248069 -0.47076 0.248108 0.224424 0.470972 -0.224532 0.0 +934 2.85 2.75 161.25 -0.459817 -0.68392 0.459953 0.309867 0.68373 -0.309803 0.0 +935 2.85 2.75 168.75 -0.661906 -0.887629 0.661947 0.389136 0.887641 -0.389112 0.0 +936 2.85 2.75 176.25 -0.785422 -1.01291 0.785357 0.436894 1.01305 -0.436953 0.0 +937 2.85 2.85 3.75 -1116.76 -835.91 1116.76 26640.2 835.91 -26640.2 0.0 +938 2.85 2.85 11.25 -610.386 -506.696 610.386 5875.84 506.696 -5875.84 0.0 +939 2.85 2.85 18.75 -255.208 -239.613 255.208 1744.42 239.613 -1744.42 0.0 +940 2.85 2.85 26.25 -73.7604 -82.5484 73.7603 437.327 82.5484 -437.327 0.0 +941 2.85 2.85 33.75 -11.1104 -18.0796 11.1103 74.9581 18.0796 -74.9581 0.0 +942 2.85 2.85 41.25 0.228715 -1.87052 -0.228784 6.31518 1.87054 -6.31516 0.0 +943 2.85 2.85 48.75 -0.186912 -0.383005 0.186932 0.552533 0.382981 -0.552553 0.0 +944 2.85 2.85 56.25 -0.516548 -0.486964 0.51651 0.427331 0.486994 -0.427316 0.0 +945 2.85 2.85 63.75 -0.277336 -0.279457 0.277442 -0.0294235 0.279516 0.0294254 0.0 +946 2.85 2.85 71.25 -0.12864 -0.127184 0.128869 -0.180718 0.127225 0.180733 0.0 +947 2.85 2.85 78.75 -0.0484987 -0.0475193 0.0484573 -0.172173 0.0474804 0.172167 0.0 +948 2.85 2.85 86.25 0.047169 0.0422314 -0.0471278 -0.173173 -0.0422364 0.173175 0.0 +949 2.85 2.85 93.75 0.132895 0.126705 -0.132882 -0.167927 -0.126598 0.167928 0.0 +950 2.85 2.85 101.25 0.176042 0.170333 -0.17625 -0.134397 -0.170485 0.134408 0.0 +951 2.85 2.85 108.75 0.163576 0.157905 -0.16355 -0.0779511 -0.157842 0.0779731 0.0 +952 2.85 2.85 116.25 0.101997 0.0960507 -0.102078 -0.014347 -0.0959807 0.0143824 0.0 +953 2.85 2.85 123.75 0.0206725 0.0134256 -0.0205836 0.0381676 -0.0135693 -0.0381435 0.0 +954 2.85 2.85 131.25 -0.0539648 -0.0618543 0.0539695 0.071669 0.061813 -0.0716401 0.0 +955 2.85 2.85 138.75 -0.126558 -0.13291 0.126595 0.096029 0.132846 -0.0960093 0.0 +956 2.85 2.85 146.25 -0.226905 -0.229729 0.2268 0.129945 0.229804 -0.130004 0.0 +957 2.85 2.85 153.75 -0.375777 -0.37653 0.375708 0.184542 0.376441 -0.184502 0.0 +958 2.85 2.85 161.25 -0.55951 -0.56228 0.559638 0.254398 0.562318 -0.254441 0.0 +959 2.85 2.85 168.75 -0.731663 -0.739479 0.731781 0.320527 0.739524 -0.32053 0.0 +960 2.85 2.85 176.25 -0.836402 -0.848187 0.836322 0.360778 0.848245 -0.36086 0.0 +961 2.85 2.95 3.75 -1111.67 -671.504 1111.67 23382.6 671.504 -23382.6 0.0 +962 2.85 2.95 11.25 -624.121 -411.338 624.121 5761.08 411.338 -5761.08 0.0 +963 2.85 2.95 18.75 -267.855 -190.585 267.855 1715.29 190.585 -1715.29 0.0 +964 2.85 2.95 26.25 -82.9178 -61.5016 82.9177 426.265 61.5016 -426.265 0.0 +965 2.85 2.95 33.75 -16.5392 -10.9568 16.5393 72.4347 10.9568 -72.4348 0.0 +966 2.85 2.95 41.25 -2.05368 -0.128524 2.05363 6.25085 0.128465 -6.25081 0.0 +967 2.85 2.95 48.75 -0.636623 -0.11763 0.63655 0.514257 0.117589 -0.514248 0.0 +968 2.85 2.95 56.25 -0.408465 -0.491652 0.408393 0.327192 0.491696 -0.327194 0.0 +969 2.85 2.95 63.75 -0.201297 -0.331339 0.201309 -0.0209138 0.331453 0.0209243 0.0 +970 2.85 2.95 71.25 -0.130914 -0.18282 0.130989 -0.130552 0.182746 0.130536 0.0 +971 2.85 2.95 78.75 -0.0608924 -0.0898709 0.0607915 -0.139463 0.0899889 0.139453 0.0 +972 2.85 2.95 86.25 0.0345738 0.00746434 -0.0344701 -0.148244 -0.00754141 0.148234 0.0 +973 2.85 2.95 93.75 0.111119 0.0976325 -0.1113 -0.142909 -0.0978809 0.142911 0.0 +974 2.85 2.95 101.25 0.151941 0.155503 -0.151976 -0.117111 -0.15543 0.11711 0.0 +975 2.85 2.95 108.75 0.145751 0.160353 -0.145553 -0.0726376 -0.160204 0.0725882 0.0 +976 2.85 2.95 116.25 0.0915158 0.110131 -0.0916919 -0.0182529 -0.110235 0.0182768 0.0 +977 2.85 2.95 123.75 0.0152377 0.0331448 -0.0151991 0.0284008 -0.0330236 -0.0284138 0.0 +978 2.85 2.95 131.25 -0.0546463 -0.0389944 0.0545777 0.0573967 0.038874 -0.0573186 0.0 +979 2.85 2.95 138.75 -0.1187 -0.104823 0.118718 0.0772008 0.104764 -0.077174 0.0 +980 2.85 2.95 146.25 -0.204059 -0.191464 0.203984 0.105389 0.191495 -0.105464 0.0 +981 2.85 2.95 153.75 -0.330797 -0.320794 0.330923 0.152322 0.320747 -0.152296 0.0 +982 2.85 2.95 161.25 -0.488129 -0.483077 0.488236 0.213067 0.483198 -0.213056 0.0 +983 2.85 2.95 168.75 -0.635592 -0.636761 0.635765 0.270692 0.636908 -0.270728 0.0 +984 2.85 2.95 176.25 -0.725217 -0.730636 0.725177 0.305753 0.730739 -0.305825 0.0 +985 2.85 3.05 3.75 -991.274 -468.465 991.274 17235.6 468.465 -17235.6 0.0 +986 2.85 3.05 11.25 -573.802 -298.761 573.802 5231.29 298.761 -5231.29 0.0 +987 2.85 3.05 18.75 -246.923 -139.586 246.923 1584.79 139.586 -1584.79 0.0 +988 2.85 3.05 26.25 -76.3431 -44.1795 76.3432 390.143 44.1795 -390.143 0.0 +989 2.85 3.05 33.75 -15.4296 -7.24375 15.4295 64.979 7.24375 -64.979 0.0 +990 2.85 3.05 41.25 -1.99485 0.0867799 1.99484 5.41934 -0.0867462 -5.41932 0.0 +991 2.85 3.05 48.75 -0.466876 -0.194309 0.466823 0.319783 0.194325 -0.319796 0.0 +992 2.85 3.05 56.25 -0.247864 -0.498556 0.247809 0.194278 0.49852 -0.194293 0.0 +993 2.85 3.05 63.75 -0.160838 -0.374237 0.160788 -0.00452736 0.374195 0.00453271 0.0 +994 2.85 3.05 71.25 -0.138726 -0.24602 0.138704 -0.0733155 0.246086 0.0732922 0.0 +995 2.85 3.05 78.75 -0.0645345 -0.137898 0.0646711 -0.10598 0.137892 0.105997 0.0 +996 2.85 3.05 86.25 0.0266641 -0.0289336 -0.0265391 -0.125218 0.0289426 0.125216 0.0 +997 2.85 3.05 93.75 0.0897391 0.0651921 -0.0895906 -0.118986 -0.0650775 0.118989 0.0 +998 2.85 3.05 101.25 0.124171 0.131613 -0.123901 -0.0965881 -0.131532 0.0965755 0.0 +999 2.85 3.05 108.75 0.12195 0.150621 -0.122014 -0.0600585 -0.150659 0.0600667 0.0 +1000 2.85 3.05 116.25 0.0781014 0.115484 -0.0778585 -0.0147582 -0.115247 0.0147179 0.0 +1001 2.85 3.05 123.75 0.0150628 0.0506384 -0.0150425 0.0236392 -0.0506457 -0.023627 0.0 +1002 2.85 3.05 131.25 -0.0400525 -0.0131487 0.0399632 0.0466779 0.0130289 -0.0466525 0.0 +1003 2.85 3.05 138.75 -0.0895184 -0.0739947 0.0894657 0.0627374 0.0740386 -0.0627861 0.0 +1004 2.85 3.05 146.25 -0.15904 -0.155412 0.159469 0.0871229 0.155461 -0.0870861 0.0 +1005 2.85 3.05 153.75 -0.267082 -0.274606 0.267172 0.127796 0.274496 -0.127765 0.0 +1006 2.85 3.05 161.25 -0.401901 -0.419629 0.401826 0.179668 0.41968 -0.179776 0.0 +1007 2.85 3.05 168.75 -0.527756 -0.553697 0.527878 0.228247 0.553582 -0.228199 0.0 +1008 2.85 3.05 176.25 -0.604226 -0.634443 0.604143 0.25757 0.634535 -0.257606 0.0 +1009 2.85 3.15 3.75 -806.102 -265.526 806.102 12165.1 265.526 -12165.1 0.0 +1010 2.85 3.15 11.25 -477.611 -181.207 477.611 4442.53 181.207 -4442.53 0.0 +1011 2.85 3.15 18.75 -202.862 -88.6434 202.862 1380.02 88.6434 -1380.02 0.0 +1012 2.85 3.15 26.25 -60.0987 -29.0515 60.0987 336.188 29.0515 -336.188 0.0 +1013 2.85 3.15 33.75 -10.968 -5.19052 10.9681 54.504 5.19046 -54.5041 0.0 +1014 2.85 3.15 41.25 -1.05094 -0.312006 1.05086 4.33851 0.311981 -4.33846 0.0 +1015 2.85 3.15 48.75 -0.213743 -0.352928 0.213728 0.164252 0.352886 -0.164263 0.0 +1016 2.85 3.15 56.25 -0.154279 -0.471869 0.154225 0.093218 0.47198 -0.0932153 0.0 +1017 2.85 3.15 63.75 -0.141604 -0.388768 0.141653 0.0126807 0.388761 -0.0126585 0.0 +1018 2.85 3.15 71.25 -0.130127 -0.294635 0.130139 -0.0263984 0.294556 0.0263117 0.0 +1019 2.85 3.15 78.75 -0.0550277 -0.180465 0.0550203 -0.073421 0.180561 0.0734297 0.0 +1020 2.85 3.15 86.25 0.0209399 -0.0643701 -0.0207919 -0.0962653 0.0644703 0.0962704 0.0 +1021 2.85 3.15 93.75 0.0659847 0.032253 -0.0661012 -0.0898107 -0.0322317 0.0898055 0.0 +1022 2.85 3.15 101.25 0.0929454 0.104785 -0.092671 -0.0721152 -0.104858 0.0721226 0.0 +1023 2.85 3.15 108.75 0.0923534 0.135562 -0.0925163 -0.0438144 -0.135405 0.0437756 0.0 +1024 2.85 3.15 116.25 0.0576885 0.115491 -0.0573926 -0.00846383 -0.115386 0.00845008 0.0 +1025 2.85 3.15 123.75 0.00835101 0.0659492 -0.00830537 0.0204391 -0.0659776 -0.020473 0.0 +1026 2.85 3.15 131.25 -0.0330033 0.0137364 0.0330472 0.0368218 -0.0138501 -0.0368043 0.0 +1027 2.85 3.15 138.75 -0.0696344 -0.0403338 0.0693805 0.0485567 0.0403552 -0.0486203 0.0 +1028 2.85 3.15 146.25 -0.123646 -0.114761 0.123498 0.0676978 0.114704 -0.0677341 0.0 +1029 2.85 3.15 153.75 -0.209228 -0.220305 0.209164 0.0995682 0.220152 -0.0994412 0.0 +1030 2.85 3.15 161.25 -0.316292 -0.3444 0.316446 0.139549 0.344477 -0.139654 0.0 +1031 2.85 3.15 168.75 -0.416182 -0.455814 0.416144 0.176494 0.455746 -0.176411 0.0 +1032 2.85 3.15 176.25 -0.476042 -0.521785 0.476 0.198621 0.521756 -0.198557 0.0 +1033 2.85 3.25 3.75 -599.006 -91.2154 599.006 8491.46 91.2155 -8491.46 0.0 +1034 2.85 3.25 11.25 -359.488 -74.6727 359.488 3559.49 74.6727 -3559.49 0.0 +1035 2.85 3.25 18.75 -148.661 -42.6777 148.661 1135.12 42.6777 -1135.12 0.0 +1036 2.85 3.25 26.25 -40.7166 -16.0322 40.7166 272.812 16.0322 -272.812 0.0 +1037 2.85 3.25 33.75 -5.97051 -3.67296 5.97039 42.68 3.67297 -42.68 0.0 +1038 2.85 3.25 41.25 -0.182688 -0.670468 0.182753 3.20438 0.670474 -3.20441 0.0 +1039 2.85 3.25 48.75 -0.0747798 -0.425329 0.0748223 0.0657742 0.425365 -0.0658515 0.0 +1040 2.85 3.25 56.25 -0.0982934 -0.398958 0.0982134 0.0220039 0.399004 -0.0220176 0.0 +1041 2.85 3.25 63.75 -0.100813 -0.360976 0.100898 0.0133885 0.360825 -0.0133447 0.0 +1042 2.85 3.25 71.25 -0.0945309 -0.307881 0.0945963 -0.00420512 0.307879 0.00421061 0.0 +1043 2.85 3.25 78.75 -0.0366795 -0.207353 0.0366632 -0.0482296 0.20741 0.0482248 0.0 +1044 2.85 3.25 86.25 0.0149887 -0.0970942 -0.0150626 -0.0654125 0.0972336 0.0654212 0.0 +1045 2.85 3.25 93.75 0.0443972 -0.00226785 -0.0443982 -0.0599009 0.00218497 0.0598939 0.0 +1046 2.85 3.25 101.25 0.0653842 0.0743707 -0.0655475 -0.0488889 -0.074459 0.048906 0.0 +1047 2.85 3.25 108.75 0.0673028 0.115282 -0.0672563 -0.0293956 -0.115121 0.0293551 0.0 +1048 2.85 3.25 116.25 0.041101 0.109791 -0.041206 -0.00426137 -0.110092 0.0043584 0.0 +1049 2.85 3.25 123.75 0.0030353 0.0756594 -0.00306469 0.0153374 -0.0756692 -0.0152926 0.0 +1050 2.85 3.25 131.25 -0.02782 0.0350328 0.0279329 0.0256415 -0.0350474 -0.0256136 0.0 +1051 2.85 3.25 138.75 -0.0538742 -0.00966993 0.0537414 0.0330967 0.00970634 -0.033162 0.0 +1052 2.85 3.25 146.25 -0.0905357 -0.070843 0.0905608 0.0460454 0.0707919 -0.045972 0.0 +1053 2.85 3.25 153.75 -0.14887 -0.15562 0.148901 0.0676893 0.155618 -0.067644 0.0 +1054 2.85 3.25 161.25 -0.22216 -0.252709 0.22219 0.0946651 0.252847 -0.0946834 0.0 +1055 2.85 3.25 168.75 -0.290593 -0.338691 0.290381 0.119487 0.33884 -0.119576 0.0 +1056 2.85 3.25 176.25 -0.3308 -0.388801 0.331427 0.13433 0.388853 -0.134296 0.0 +1057 2.85 3.35 3.75 -386.528 33.5021 386.528 5634.36 -33.5021 -5634.36 0.0 +1058 2.85 3.35 11.25 -232.313 5.67109 232.313 2604.32 -5.67109 -2604.32 0.0 +1059 2.85 3.35 18.75 -91.9697 -7.27714 91.9697 849.253 7.27716 -849.253 0.0 +1060 2.85 3.35 26.25 -22.1609 -5.78613 22.161 200.148 5.78612 -200.148 0.0 +1061 2.85 3.35 33.75 -1.98022 -2.12648 1.98024 29.7672 2.12648 -29.7672 0.0 +1062 2.85 3.35 41.25 0.243179 -0.637377 -0.243178 2.04091 0.637344 -2.04094 0.0 +1063 2.85 3.35 48.75 -0.0543799 -0.361761 0.0543227 0.0128587 0.36182 -0.0128186 0.0 +1064 2.85 3.35 56.25 -0.053243 -0.315179 0.0533037 -0.0175621 0.315135 0.0175499 0.0 +1065 2.85 3.35 63.75 -0.0463022 -0.314223 0.0463235 0.00311652 0.314212 -0.00320789 0.0 +1066 2.85 3.35 71.25 -0.0532898 -0.296211 0.0534137 -0.000155585 0.29602 0.000135295 0.0 +1067 2.85 3.35 78.75 -0.0212587 -0.22246 0.0212696 -0.0288431 0.222559 0.0288631 0.0 +1068 2.85 3.35 86.25 0.00889954 -0.125343 -0.00894718 -0.0369629 0.125394 0.0369644 0.0 +1069 2.85 3.35 93.75 0.0262325 -0.0313862 -0.0263584 -0.0340369 0.0311982 0.0340506 0.0 +1070 2.85 3.35 101.25 0.0415953 0.0498466 -0.0414478 -0.0293926 -0.0498895 0.0293844 0.0 +1071 2.85 3.35 108.75 0.0450451 0.0995096 -0.0449831 -0.0178232 -0.0997351 0.0178778 0.0 +1072 2.85 3.35 116.25 0.028077 0.105738 -0.0281433 -0.00230595 -0.105795 0.00235292 0.0 +1073 2.85 3.35 123.75 0.00116088 0.0815732 -0.000852722 0.00942911 -0.0816637 -0.00933158 0.0 +1074 2.85 3.35 131.25 -0.0216069 0.0479562 0.0217652 0.0156247 -0.0476846 -0.0157325 0.0 +1075 2.85 3.35 138.75 -0.0380909 0.0111308 0.0380157 0.0201099 -0.0113054 -0.0200733 0.0 +1076 2.85 3.35 146.25 -0.0570642 -0.0359703 0.0570676 0.0273788 0.0359094 -0.0273053 0.0 +1077 2.85 3.35 153.75 -0.0874487 -0.0993169 0.0874531 0.0394423 0.0994037 -0.0393806 0.0 +1078 2.85 3.35 161.25 -0.127843 -0.172492 0.127557 0.054893 0.172359 -0.0549082 0.0 +1079 2.85 3.35 168.75 -0.166559 -0.237682 0.166614 0.0695468 0.237554 -0.0695277 0.0 +1080 2.85 3.35 176.25 -0.191 -0.276276 0.19078 0.0784958 0.276377 -0.0785403 0.0 +1081 2.85 3.45 3.75 -161.588 70.6187 161.588 2741.33 -70.6187 -2741.33 0.0 +1082 2.85 3.45 11.25 -95.5114 34.9158 95.5114 1355.81 -34.9158 -1355.81 0.0 +1083 2.85 3.45 18.75 -34.6683 8.27267 34.6684 448.865 -8.27268 -448.865 0.0 +1084 2.85 3.45 26.25 -6.16493 -0.139582 6.16494 102.857 0.139618 -102.857 0.0 +1085 2.85 3.45 33.75 0.422229 -0.589501 -0.422207 14.2949 0.589425 -14.2948 0.0 +1086 2.85 3.45 41.25 0.271293 -0.179716 -0.271334 0.90093 0.179724 -0.900935 0.0 +1087 2.85 3.45 48.75 -0.0728654 -0.170806 0.0729137 0.0252674 0.1707 -0.025252 0.0 +1088 2.85 3.45 56.25 -0.0333377 -0.213039 0.0332742 -0.0156257 0.212999 0.0155434 0.0 +1089 2.85 3.45 63.75 -0.0152903 -0.227014 0.0151849 -0.00379666 0.227029 0.00381385 0.0 +1090 2.85 3.45 71.25 -0.0235692 -0.224061 0.0235144 -0.000903934 0.22407 0.000862594 0.0 +1091 2.85 3.45 78.75 -0.00941949 -0.180683 0.00940751 -0.0122182 0.180688 0.0122354 0.0 +1092 2.85 3.45 86.25 0.00386563 -0.108855 -0.00384482 -0.0147672 0.108894 0.0147696 0.0 +1093 2.85 3.45 93.75 0.00738598 -0.0352297 -0.00746621 -0.0134146 0.0352537 0.0134097 0.0 +1094 2.85 3.45 101.25 0.0113163 0.0272447 -0.0112177 -0.0108832 -0.027162 0.0109037 0.0 +1095 2.85 3.45 108.75 0.0143535 0.0674421 -0.0144727 -0.00585159 -0.0674317 0.00583747 0.0 +1096 2.85 3.45 116.25 0.0102386 0.0775271 -0.0102071 -0.000339014 -0.0776401 0.000348303 0.0 +1097 2.85 3.45 123.75 2.58732e-05 0.0640245 -4.10589e-05 0.00384167 -0.0641439 -0.00376402 0.0 +1098 2.85 3.45 131.25 -0.00902431 0.0415235 0.00900971 0.00644527 -0.0416055 -0.00641701 0.0 +1099 2.85 3.45 138.75 -0.0130822 0.0181696 0.0131824 0.00773263 -0.0182103 -0.00771311 0.0 +1100 2.85 3.45 146.25 -0.0161839 -0.00998922 0.016076 0.00888536 0.00978667 -0.00879601 0.0 +1101 2.85 3.45 153.75 -0.0242202 -0.0483692 0.0241807 0.011811 0.0483358 -0.0118472 0.0 +1102 2.85 3.45 161.25 -0.0396328 -0.0952296 0.0395522 0.0172745 0.0951821 -0.0172176 0.0 +1103 2.85 3.45 168.75 -0.0578248 -0.139644 0.0577311 0.0236934 0.13953 -0.0236387 0.0 +1104 2.85 3.45 176.25 -0.0700834 -0.166806 0.0701114 0.0280544 0.166621 -0.0279388 0.0 +1105 2.85 3.55 3.75 -31.029 33.8429 31.029 807.354 -33.8429 -807.354 0.0 +1106 2.85 3.55 11.25 -16.6941 17.1581 16.6942 418.065 -17.1581 -418.065 0.0 +1107 2.85 3.55 18.75 -3.99472 4.08748 3.9947 139.471 -4.08747 -139.471 0.0 +1108 2.85 3.55 26.25 0.82754 0.00960473 -0.827538 30.9637 -0.00959943 -30.9637 0.0 +1109 2.85 3.55 33.75 0.904557 -0.081934 -0.904543 4.11608 0.0819614 -4.11609 0.0 +1110 2.85 3.55 41.25 0.170681 0.0848305 -0.170682 0.346509 -0.0848039 -0.34653 0.0 +1111 2.85 3.55 48.75 -0.0666717 -0.0106917 0.0666836 0.0541797 0.0106909 -0.0541811 0.0 +1112 2.85 3.55 56.25 -0.0367163 -0.0711844 0.0367427 -0.00758183 0.0712025 0.00758489 0.0 +1113 2.85 3.55 63.75 -0.00980718 -0.0797592 0.00983424 -0.00697712 0.0797424 0.00697812 0.0 +1114 2.85 3.55 71.25 -0.00586824 -0.0828521 0.00590764 -3.50261e-07 0.0828154 -9.47724e-06 0.0 +1115 2.85 3.55 78.75 -0.000602709 -0.0682983 0.000612821 -0.00212227 0.0683145 0.00213184 0.0 +1116 2.85 3.55 86.25 0.000973121 -0.0398569 -0.000961009 -0.00335451 0.0398316 0.00334909 0.0 +1117 2.85 3.55 93.75 -0.00358082 -0.0150889 0.00357048 -0.00152868 0.0150508 0.00152981 0.0 +1118 2.85 3.55 101.25 -0.00603736 0.00394172 0.00605293 0.000730934 -0.00393071 -0.000744155 0.0 +1119 2.85 3.55 108.75 -0.00335262 0.0195109 0.00322804 0.00102238 -0.0194668 -0.00104163 0.0 +1120 2.85 3.55 116.25 0.000444349 0.027755 -0.000387332 8.69624e-05 -0.0277462 -9.75392e-05 0.0 +1121 2.85 3.55 123.75 0.0014088 0.0269113 -0.00138674 -7.73086e-05 -0.0268849 6.29337e-05 0.0 +1122 2.85 3.55 131.25 0.00165964 0.0217477 -0.00165364 0.000223061 -0.0218041 -0.000187964 0.0 +1123 2.85 3.55 138.75 0.00401875 0.0169663 -0.00395318 -0.000703326 -0.016976 0.000717988 0.0 +1124 2.85 3.55 146.25 0.00768509 0.0118145 -0.00765824 -0.00287592 -0.0118411 0.00289573 0.0 +1125 2.85 3.55 153.75 0.00912573 0.00261415 -0.00905729 -0.00443259 -0.00257542 0.00443667 0.0 +1126 2.85 3.55 161.25 0.0057808 -0.0119115 -0.00584887 -0.00390544 0.0118818 0.00391874 0.0 +1127 2.85 3.55 168.75 -0.000422092 -0.0276521 0.000431626 -0.00177835 0.0276894 0.00174946 0.0 +1128 2.85 3.55 176.25 -0.00538109 -0.0379719 0.00540295 7.43942e-05 0.0379802 -5.26705e-05 0.0 +1129 2.85 3.65 3.75 0.117993 2.41395 -0.117994 63.6242 -2.41395 -63.6242 0.0 +1130 2.85 3.65 11.25 0.547196 0.863222 -0.547196 34.0061 -0.86322 -34.0061 0.0 +1131 2.85 3.65 18.75 0.745937 -0.193692 -0.745936 11.4296 0.193693 -11.4296 0.0 +1132 2.85 3.65 26.25 0.543519 -0.28335 -0.54352 2.53726 0.28335 -2.53726 0.0 +1133 2.85 3.65 33.75 0.224853 -0.0795795 -0.224852 0.395802 0.0795803 -0.395805 0.0 +1134 2.85 3.65 41.25 0.0308566 0.0096513 -0.030854 0.0760108 -0.00965396 -0.0760089 0.0 +1135 2.85 3.65 48.75 -0.0200071 0.0114374 0.0200007 0.0152694 -0.0114346 -0.0152666 0.0 +1136 2.85 3.65 56.25 -0.0121781 0.00806958 0.0121778 -0.00463886 -0.00806824 0.00463935 0.0 +1137 2.85 3.65 63.75 -0.00240079 0.00691829 0.00239728 -0.00287853 -0.00691891 0.00287832 0.0 +1138 2.85 3.65 71.25 -0.000113974 0.00344927 0.000114402 0.000925612 -0.00345159 -0.000924517 0.0 +1139 2.85 3.65 78.75 -0.000150972 0.00204618 0.000149514 0.00127176 -0.00204528 -0.00127259 0.0 +1140 2.85 3.65 86.25 -0.00063721 0.00167632 0.000641885 0.000872705 -0.00167479 -0.000872293 0.0 +1141 2.85 3.65 93.75 -0.00144962 -0.000316034 0.00144811 0.00113858 0.000313733 -0.00113842 0.0 +1142 2.85 3.65 101.25 -0.00167523 -0.00216785 0.00167369 0.00123363 0.00216868 -0.00123425 0.0 +1143 2.85 3.65 108.75 -0.00110878 -0.00207464 0.00110977 0.00064396 0.00207751 -0.000643732 0.0 +1144 2.85 3.65 116.25 -0.000764004 -0.00128655 0.000766131 0.000103318 0.00128453 -0.000103182 0.0 +1145 2.85 3.65 123.75 -0.00123412 -0.00134957 0.00123183 0.000216939 0.00135724 -0.000220275 0.0 +1146 2.85 3.65 131.25 -0.00184917 -0.00183778 0.00184664 0.000577507 0.00184059 -0.000579396 0.0 +1147 2.85 3.65 138.75 -0.00163391 -0.00138008 0.00162307 0.000515544 0.00137553 -0.000512344 0.0 +1148 2.85 3.65 146.25 -0.000376327 0.000499681 0.00037387 -6.6379e-06 -0.000506003 1.01884e-05 0.0 +1149 2.85 3.65 153.75 0.00121458 0.00310539 -0.00122162 -0.000485719 -0.00311088 0.000488173 0.0 +1150 2.85 3.65 161.25 0.00238865 0.00543453 -0.0023833 -0.00051915 -0.00542809 0.000516147 0.0 +1151 2.85 3.65 168.75 0.00285962 0.00692717 -0.00285792 -0.000171476 -0.00692344 0.000168255 0.0 +1152 2.85 3.65 176.25 0.00292307 0.00758779 -0.00292581 0.00016883 -0.00759567 -0.000164093 0.0 +1153 2.95 2.55 3.75 -252.721 -1050.76 252.721 6595.19 1050.76 -6595.19 0.0 +1154 2.95 2.55 11.25 -41.1238 -768.829 41.1238 2888.85 768.829 -2888.85 0.0 +1155 2.95 2.55 18.75 118.417 -449.255 -118.417 900.553 449.255 -900.553 0.0 +1156 2.95 2.55 26.25 156.92 -210.895 -156.92 167.43 210.895 -167.43 0.0 +1157 2.95 2.55 33.75 119.104 -74.0526 -119.104 -18.6078 74.0526 18.6078 0.0 +1158 2.95 2.55 41.25 65.7986 -13.1995 -65.7986 -30.6797 13.1995 30.6797 0.0 +1159 2.95 2.55 48.75 29.0332 5.91326 -29.0332 -15.4024 -5.91326 15.4024 0.0 +1160 2.95 2.55 56.25 11.4878 8.02601 -11.4878 -6.73731 -8.026 6.7373 0.0 +1161 2.95 2.55 63.75 4.66214 5.91098 -4.66202 -3.9881 -5.91102 3.98809 0.0 +1162 2.95 2.55 71.25 1.77619 4.12825 -1.77611 -3.46574 -4.12825 3.46573 0.0 +1163 2.95 2.55 78.75 0.151273 3.12532 -0.151223 -3.50261 -3.12532 3.50263 0.0 +1164 2.95 2.55 86.25 -0.848703 2.18442 0.848724 -3.31518 -2.18449 3.31517 0.0 +1165 2.95 2.55 93.75 -1.36638 0.946406 1.36638 -2.63915 -0.946487 2.63915 0.0 +1166 2.95 2.55 101.25 -1.42623 -0.377787 1.42617 -1.69714 0.377648 1.69715 0.0 +1167 2.95 2.55 108.75 -0.982806 -1.42876 0.982806 -0.865233 1.42871 0.865248 0.0 +1168 2.95 2.55 116.25 -0.0278435 -2.03668 0.0278263 -0.352266 2.0367 0.352236 0.0 +1169 2.95 2.55 123.75 1.31816 -2.25352 -1.31823 -0.14086 2.25366 0.140835 0.0 +1170 2.95 2.55 131.25 2.8161 -2.2369 -2.81616 -0.0975587 2.2368 0.0975804 0.0 +1171 2.95 2.55 138.75 4.19661 -2.14695 -4.1966 -0.0893642 2.14695 0.0893633 0.0 +1172 2.95 2.55 146.25 5.25737 -2.09866 -5.25733 -0.0396033 2.09866 0.0396395 0.0 +1173 2.95 2.55 153.75 5.92169 -2.14378 -5.92174 0.0676359 2.14379 -0.0676218 0.0 +1174 2.95 2.55 161.25 6.2371 -2.26995 -6.23714 0.206683 2.26994 -0.206718 0.0 +1175 2.95 2.55 168.75 6.32882 -2.41823 -6.32875 0.334294 2.41818 -0.334278 0.0 +1176 2.95 2.55 176.25 6.33197 -2.5165 -6.33197 0.409999 2.51647 -0.40999 0.0 +1177 2.95 2.65 3.75 -602.404 -1044.08 602.403 10359.8 1044.08 -10359.8 0.0 +1178 2.95 2.65 11.25 -280.258 -724.735 280.258 3883.61 724.735 -3883.61 0.0 +1179 2.95 2.65 18.75 -31.2855 -399.161 31.2855 1185.42 399.161 -1185.42 0.0 +1180 2.95 2.65 26.25 67.6443 -176.276 -67.6443 254.871 176.276 -254.871 0.0 +1181 2.95 2.65 33.75 67.6221 -60.3361 -67.6221 13.3469 60.3361 -13.3469 0.0 +1182 2.95 2.65 41.25 37.2303 -14.1507 -37.2303 -15.1485 14.1507 15.1485 0.0 +1183 2.95 2.65 48.75 14.0035 -0.570849 -14.0035 -7.01654 0.570878 7.01655 0.0 +1184 2.95 2.65 56.25 3.96826 1.75692 -3.96826 -2.30424 -1.75694 2.30425 0.0 +1185 2.95 2.65 63.75 1.03968 1.41412 -1.03973 -1.31005 -1.41411 1.31004 0.0 +1186 2.95 2.65 71.25 0.218951 0.967353 -0.218964 -1.22938 -0.967351 1.22938 0.0 +1187 2.95 2.65 78.75 -0.174997 0.772767 0.175075 -1.2882 -0.772773 1.2882 0.0 +1188 2.95 2.65 86.25 -0.393839 0.559177 0.393914 -1.24166 -0.559238 1.24165 0.0 +1189 2.95 2.65 93.75 -0.47265 0.167892 0.472634 -0.971798 -0.167863 0.971793 0.0 +1190 2.95 2.65 101.25 -0.415086 -0.29444 0.415096 -0.582018 0.294494 0.582025 0.0 +1191 2.95 2.65 108.75 -0.18344 -0.657303 0.1835 -0.251448 0.657204 0.251466 0.0 +1192 2.95 2.65 116.25 0.242862 -0.853042 -0.242735 -0.0667618 0.853138 0.0667293 0.0 +1193 2.95 2.65 123.75 0.816898 -0.9163 -0.817068 -0.00551971 0.916326 0.00551894 0.0 +1194 2.95 2.65 131.25 1.43137 -0.918518 -1.43133 0.000272837 0.918644 -0.000308227 0.0 +1195 2.95 2.65 138.75 1.95867 -0.929005 -1.95862 0.0112189 0.929075 -0.011238 0.0 +1196 2.95 2.65 146.25 2.30364 -0.998983 -2.30361 0.0592927 0.99898 -0.059327 0.0 +1197 2.95 2.65 153.75 2.4381 -1.14713 -2.43811 0.146803 1.14716 -0.146836 0.0 +1198 2.95 2.65 161.25 2.40678 -1.34935 -2.40669 0.254078 1.34942 -0.254097 0.0 +1199 2.95 2.65 168.75 2.30131 -1.54572 -2.3013 0.350716 1.54578 -0.350713 0.0 +1200 2.95 2.65 176.25 2.21842 -1.66688 -2.21834 0.407733 1.66692 -0.407764 0.0 +1201 2.95 2.75 3.75 -921.349 -993.633 921.349 15774.2 993.633 -15774.2 0.0 +1202 2.95 2.75 11.25 -484.503 -651.799 484.503 4799.82 651.799 -4799.82 0.0 +1203 2.95 2.75 18.75 -156.849 -336.509 156.849 1421.48 336.509 -1421.48 0.0 +1204 2.95 2.75 26.25 -5.03783 -135.732 5.03782 322.829 135.732 -322.829 0.0 +1205 2.95 2.75 33.75 28.3547 -41.434 -28.3547 36.1083 41.434 -36.1083 0.0 +1206 2.95 2.75 41.25 17.8836 -9.27057 -17.8837 -5.3871 9.27056 5.38709 0.0 +1207 2.95 2.75 48.75 5.55648 -1.46767 -5.55657 -2.51898 1.46764 2.519 0.0 +1208 2.95 2.75 56.25 0.672106 -0.0883279 -0.672198 -0.334779 0.0883496 0.334765 0.0 +1209 2.95 2.75 63.75 -0.194927 0.0690679 0.194963 -0.280915 -0.0690525 0.280893 0.0 +1210 2.95 2.75 71.25 -0.206856 0.0649187 0.206763 -0.378435 -0.0649176 0.378425 0.0 +1211 2.95 2.75 78.75 -0.186711 0.113908 0.186572 -0.418937 -0.113823 0.418941 0.0 +1212 2.95 2.75 86.25 -0.14961 0.156382 0.149622 -0.426505 -0.156396 0.426506 0.0 +1213 2.95 2.75 93.75 -0.0954388 0.111367 0.0953423 -0.345344 -0.111332 0.345334 0.0 +1214 2.95 2.75 101.25 -0.0328122 0.00794576 0.032972 -0.207227 -0.00797229 0.207241 0.0 +1215 2.95 2.75 108.75 0.054673 -0.0891922 -0.0546091 -0.0841935 0.0892434 0.0841691 0.0 +1216 2.95 2.75 116.25 0.181234 -0.157367 -0.181265 -0.0087282 0.157339 0.00873243 0.0 +1217 2.95 2.75 123.75 0.34012 -0.205051 -0.340198 0.0264405 0.205132 -0.0264545 0.0 +1218 2.95 2.75 131.25 0.502317 -0.247373 -0.502348 0.0429474 0.247218 -0.0428813 0.0 +1219 2.95 2.75 138.75 0.621852 -0.305681 -0.622162 0.0628186 0.305576 -0.0628133 0.0 +1220 2.95 2.75 146.25 0.656682 -0.406771 -0.656592 0.101823 0.406971 -0.101931 0.0 +1221 2.95 2.75 153.75 0.591488 -0.564489 -0.591646 0.163918 0.564573 -0.163963 0.0 +1222 2.95 2.75 161.25 0.454619 -0.760373 -0.454635 0.239232 0.760289 -0.2392 0.0 +1223 2.95 2.75 168.75 0.305915 -0.944156 -0.305938 0.307995 0.944217 -0.308028 0.0 +1224 2.95 2.75 176.25 0.210804 -1.05602 -0.210888 0.349082 1.05601 -0.34907 0.0 +1225 2.95 2.85 3.75 -1152.1 -884.325 1152.1 22433.3 884.325 -22433.3 0.0 +1226 2.95 2.85 11.25 -623.249 -554.368 623.249 5446.55 554.368 -5446.55 0.0 +1227 2.95 2.85 18.75 -243.026 -270.991 243.026 1573.49 270.991 -1573.49 0.0 +1228 2.95 2.85 26.25 -54.9922 -98.9789 54.9921 364.541 98.9789 -364.541 0.0 +1229 2.95 2.85 33.75 2.25373 -25.1037 -2.25376 49.691 25.1036 -49.691 0.0 +1230 2.95 2.85 41.25 6.24999 -4.21281 -6.25004 -0.0158362 4.21279 0.015854 0.0 +1231 2.95 2.85 48.75 1.46896 -0.83917 -1.46896 -0.516745 0.839147 0.51676 0.0 +1232 2.95 2.85 56.25 -0.371828 -0.443561 0.371951 0.300591 0.443459 -0.300568 0.0 +1233 2.95 2.85 63.75 -0.390584 -0.244547 0.39061 -0.00488443 0.244578 0.00485482 0.0 +1234 2.95 2.85 71.25 -0.227523 -0.141639 0.22751 -0.135266 0.141661 0.135279 0.0 +1235 2.95 2.85 78.75 -0.13169 -0.0500631 0.131746 -0.158901 0.0499834 0.158894 0.0 +1236 2.95 2.85 86.25 -0.0383226 0.048949 0.0384519 -0.178632 -0.048876 0.178639 0.0 +1237 2.95 2.85 93.75 0.0424506 0.108468 -0.0424569 -0.162363 -0.108402 0.162362 0.0 +1238 2.95 2.85 101.25 0.0951102 0.123599 -0.0950067 -0.114705 -0.123527 0.114684 0.0 +1239 2.95 2.85 108.75 0.118329 0.108127 -0.118294 -0.059624 -0.107977 0.0595957 0.0 +1240 2.95 2.85 116.25 0.115747 0.0657013 -0.115496 -0.00921956 -0.0657449 0.00923083 0.0 +1241 2.95 2.85 123.75 0.0997312 0.00632325 -0.0998366 0.0300757 -0.00638085 -0.0300905 0.0 +1242 2.95 2.85 131.25 0.0820412 -0.0544768 -0.0820477 0.0562421 0.0545567 -0.0562266 0.0 +1243 2.95 2.85 138.75 0.0543383 -0.118472 -0.0543542 0.0766667 0.118496 -0.0766528 0.0 +1244 2.95 2.85 146.25 -0.00685308 -0.206793 0.00693165 0.104336 0.206705 -0.104299 0.0 +1245 2.95 2.85 153.75 -0.116153 -0.336589 0.116017 0.147362 0.336516 -0.147325 0.0 +1246 2.95 2.85 161.25 -0.2593 -0.497512 0.259351 0.201965 0.497407 -0.201901 0.0 +1247 2.95 2.85 168.75 -0.396397 -0.649488 0.396361 0.253751 0.649379 -0.253726 0.0 +1248 2.95 2.85 176.25 -0.480441 -0.742274 0.480289 0.285392 0.74211 -0.285331 0.0 +1249 2.95 2.95 3.75 -1235.79 -703.549 1235.79 26126.6 703.549 -26126.6 0.0 +1250 2.95 2.95 11.25 -677.675 -435.614 677.675 5671.31 435.614 -5671.31 0.0 +1251 2.95 2.95 18.75 -281.882 -206.464 281.882 1620.38 206.464 -1620.38 0.0 +1252 2.95 2.95 26.25 -80.142 -69.4145 80.142 377.367 69.4145 -377.367 0.0 +1253 2.95 2.95 33.75 -11.535 -14.0454 11.535 55.1741 14.0454 -55.1741 0.0 +1254 2.95 2.95 41.25 0.444691 -1.06867 -0.444678 2.44606 1.06872 -2.44609 0.0 +1255 2.95 2.95 48.75 -0.095339 -0.280002 0.095379 0.150135 0.280037 -0.150155 0.0 +1256 2.95 2.95 56.25 -0.487332 -0.457247 0.487298 0.373103 0.457341 -0.373058 0.0 +1257 2.95 2.95 63.75 -0.309733 -0.308057 0.309669 0.0352679 0.308082 -0.0352801 0.0 +1258 2.95 2.95 71.25 -0.189494 -0.187337 0.189429 -0.0767338 0.187338 0.0767722 0.0 +1259 2.95 2.95 78.75 -0.100558 -0.0943326 0.100538 -0.103742 0.0942838 0.103711 0.0 +1260 2.95 2.95 86.25 -0.00127159 0.00259697 0.00111691 -0.124177 -0.0027075 0.124174 0.0 +1261 2.95 2.95 93.75 0.0781938 0.0795056 -0.0783669 -0.119644 -0.0795165 0.119632 0.0 +1262 2.95 2.95 101.25 0.125437 0.125749 -0.125346 -0.0954926 -0.125695 0.0954816 0.0 +1263 2.95 2.95 108.75 0.131842 0.132451 -0.1318 -0.0582993 -0.132316 0.0582686 0.0 +1264 2.95 2.95 116.25 0.094036 0.0945768 -0.0939986 -0.013007 -0.0944018 0.0129685 0.0 +1265 2.95 2.95 123.75 0.031853 0.0309302 -0.0318676 0.0276584 -0.0309157 -0.0276663 0.0 +1266 2.95 2.95 131.25 -0.0289236 -0.0307662 0.0290267 0.0542911 0.0309129 -0.0543246 0.0 +1267 2.95 2.95 138.75 -0.0860191 -0.0873603 0.0858184 0.0715543 0.0871918 -0.0715138 0.0 +1268 2.95 2.95 146.25 -0.159015 -0.159395 0.158823 0.092785 0.159333 -0.0927604 0.0 +1269 2.95 2.95 153.75 -0.264066 -0.265928 0.264092 0.127317 0.266003 -0.127385 0.0 +1270 2.95 2.95 161.25 -0.392832 -0.399313 0.392736 0.172881 0.399453 -0.172904 0.0 +1271 2.95 2.95 168.75 -0.51305 -0.525949 0.512818 0.216982 0.526087 -0.217102 0.0 +1272 2.95 2.95 176.25 -0.585362 -0.603164 0.585535 0.244165 0.603114 -0.244128 0.0 +1273 2.95 3.05 3.75 -1152 -470.691 1152 22546.9 470.691 -22546.9 0.0 +1274 2.95 3.05 11.25 -646.366 -302.989 646.366 5436.44 302.989 -5436.44 0.0 +1275 2.95 3.05 18.75 -274.735 -144.566 274.735 1560.79 144.566 -1560.79 0.0 +1276 2.95 3.05 26.25 -82.9595 -46.7837 82.9596 363.128 46.7837 -363.128 0.0 +1277 2.95 3.05 33.75 -15.5348 -7.90904 15.5348 54.2888 7.90907 -54.2887 0.0 +1278 2.95 3.05 41.25 -1.52533 0.0877815 1.52529 3.23039 -0.0877658 -3.23043 0.0 +1279 2.95 3.05 48.75 -0.429791 -0.130249 0.429777 0.249314 0.130206 -0.249273 0.0 +1280 2.95 3.05 56.25 -0.354386 -0.465805 0.3544 0.285906 0.465883 -0.285905 0.0 +1281 2.95 3.05 63.75 -0.230807 -0.353693 0.230714 0.0451008 0.353768 -0.0451234 0.0 +1282 2.95 3.05 71.25 -0.171943 -0.228248 0.172051 -0.0442061 0.228171 0.0442394 0.0 +1283 2.95 3.05 78.75 -0.0886759 -0.125763 0.0886157 -0.0870429 0.125748 0.0870611 0.0 +1284 2.95 3.05 86.25 0.00406016 -0.0290639 -0.00400943 -0.106637 0.0291333 0.106635 0.0 +1285 2.95 3.05 93.75 0.0709324 0.0512843 -0.0709031 -0.0997352 -0.0513256 0.0997471 0.0 +1286 2.95 3.05 101.25 0.112173 0.109307 -0.112111 -0.081026 -0.10938 0.0810188 0.0 +1287 2.95 3.05 108.75 0.118241 0.127448 -0.118156 -0.0508854 -0.127498 0.0509172 0.0 +1288 2.95 3.05 116.25 0.082375 0.0967194 -0.0826216 -0.0115758 -0.096743 0.0116038 0.0 +1289 2.95 3.05 123.75 0.0249719 0.0392243 -0.0250633 0.0233571 -0.0393156 -0.0232965 0.0 +1290 2.95 3.05 131.25 -0.0283614 -0.0168684 0.0282743 0.0451621 0.0168661 -0.045173 0.0 +1291 2.95 3.05 138.75 -0.0768736 -0.0688048 0.077069 0.0594051 0.068716 -0.0593073 0.0 +1292 2.95 3.05 146.25 -0.141563 -0.136731 0.141568 0.0784955 0.136426 -0.0784076 0.0 +1293 2.95 3.05 153.75 -0.236122 -0.235072 0.236058 0.109983 0.235346 -0.110141 0.0 +1294 2.95 3.05 161.25 -0.351579 -0.354851 0.351474 0.150951 0.354689 -0.150832 0.0 +1295 2.95 3.05 168.75 -0.458428 -0.465918 0.458345 0.190063 0.465592 -0.18999 0.0 +1296 2.95 3.05 176.25 -0.522577 -0.532559 0.52258 0.213967 0.532625 -0.214084 0.0 +1297 2.95 3.15 3.75 -947.105 -234.064 947.105 16388.2 234.064 -16388.2 0.0 +1298 2.95 3.15 11.25 -544.957 -169.572 544.957 4831.85 169.572 -4831.85 0.0 +1299 2.95 3.15 18.75 -231.218 -87.4264 231.218 1411.96 87.4264 -1411.96 0.0 +1300 2.95 3.15 26.25 -69.489 -29.5946 69.489 327.211 29.5945 -327.211 0.0 +1301 2.95 3.15 33.75 -13.2484 -5.06717 13.2484 48.9414 5.06717 -48.9414 0.0 +1302 2.95 3.15 41.25 -1.4679 0.0238403 1.46795 3.15011 -0.0239097 -3.15014 0.0 +1303 2.95 3.15 48.75 -0.31652 -0.227201 0.316586 0.172569 0.227204 -0.17262 0.0 +1304 2.95 3.15 56.25 -0.21369 -0.480095 0.213689 0.184024 0.480141 -0.184087 0.0 +1305 2.95 3.15 63.75 -0.176969 -0.390853 0.176921 0.0560194 0.390826 -0.0559763 0.0 +1306 2.95 3.15 71.25 -0.150417 -0.269717 0.150456 -0.0151382 0.269771 0.0150882 0.0 +1307 2.95 3.15 78.75 -0.0732588 -0.158111 0.073298 -0.0675252 0.157991 0.0675219 0.0 +1308 2.95 3.15 86.25 0.0011828 -0.0578942 -0.0013546 -0.0836453 0.0579193 0.083656 0.0 +1309 2.95 3.15 93.75 0.0495663 0.0262723 -0.0495336 -0.0758505 -0.0265178 0.0758585 0.0 +1310 2.95 3.15 101.25 0.0825033 0.0923783 -0.0825646 -0.0624571 -0.0924447 0.0624949 0.0 +1311 2.95 3.15 108.75 0.0903024 0.12085 -0.0901393 -0.0395117 -0.120852 0.0395202 0.0 +1312 2.95 3.15 116.25 0.0638444 0.102339 -0.0638579 -0.00894728 -0.102235 0.00890468 0.0 +1313 2.95 3.15 123.75 0.0220461 0.0572511 -0.0219022 0.0169359 -0.0570113 -0.0169543 0.0 +1314 2.95 3.15 131.25 -0.015441 0.00943891 0.0156538 0.0325133 -0.00947592 -0.0324612 0.0 +1315 2.95 3.15 138.75 -0.0518112 -0.0403117 0.0516345 0.043965 0.0403656 -0.0440096 0.0 +1316 2.95 3.15 146.25 -0.104883 -0.106935 0.104923 0.0610883 0.106832 -0.0610049 0.0 +1317 2.95 3.15 153.75 -0.185793 -0.19961 0.185681 0.0885896 0.199403 -0.0885392 0.0 +1318 2.95 3.15 161.25 -0.283884 -0.306665 0.283899 0.123061 0.306488 -0.122974 0.0 +1319 2.95 3.15 168.75 -0.3736 -0.401945 0.373662 0.155182 0.401946 -0.155094 0.0 +1320 2.95 3.15 176.25 -0.427053 -0.458118 0.427085 0.174567 0.458223 -0.174634 0.0 +1321 2.95 3.25 3.75 -684.962 -33.597 684.962 11353.2 33.597 -11353.2 0.0 +1322 2.95 3.25 11.25 -400.069 -51.4433 400.069 4016.56 51.4433 -4016.56 0.0 +1323 2.95 3.25 18.75 -165.833 -38.5931 165.833 1203.1 38.5931 -1203.1 0.0 +1324 2.95 3.25 26.25 -47.263 -16.6148 47.263 276.987 16.6148 -276.987 0.0 +1325 2.95 3.25 33.75 -8.14408 -3.80756 8.14405 40.878 3.80754 -40.8779 0.0 +1326 2.95 3.25 41.25 -0.735673 -0.396549 0.73574 2.63773 0.396509 -2.63772 0.0 +1327 2.95 3.25 48.75 -0.150431 -0.333017 0.150544 0.0672603 0.332896 -0.0672187 0.0 +1328 2.95 3.25 56.25 -0.10876 -0.446971 0.10866 0.0972865 0.44696 -0.0973988 0.0 +1329 2.95 3.25 63.75 -0.118865 -0.37823 0.118992 0.0520019 0.378268 -0.052 0.0 +1330 2.95 3.25 71.25 -0.109895 -0.280626 0.109945 -0.000890606 0.280499 0.000905523 0.0 +1331 2.95 3.25 78.75 -0.0507365 -0.181073 0.0507334 -0.0461242 0.18097 0.0461348 0.0 +1332 2.95 3.25 86.25 -0.000734511 -0.0871476 0.00060714 -0.0555662 0.0872154 0.0555746 0.0 +1333 2.95 3.25 93.75 0.0311957 -0.00236195 -0.0311942 -0.0515041 0.00259597 0.0514843 0.0 +1334 2.95 3.25 101.25 0.0572093 0.0688848 -0.0571052 -0.0452318 -0.0687382 0.0452149 0.0 +1335 2.95 3.25 108.75 0.064287 0.106942 -0.0642778 -0.029198 -0.106939 0.0292002 0.0 +1336 2.95 3.25 116.25 0.0445212 0.10208 -0.0444717 -0.00721917 -0.102122 0.00721939 0.0 +1337 2.95 3.25 123.75 0.0135976 0.0703346 -0.0132914 0.0101515 -0.070214 -0.0102111 0.0 +1338 2.95 3.25 131.25 -0.0135575 0.0313234 0.0136726 0.0203596 -0.0316066 -0.0203055 0.0 +1339 2.95 3.25 138.75 -0.0393187 -0.0123616 0.0392606 0.0289017 0.0125322 -0.0289811 0.0 +1340 2.95 3.25 146.25 -0.0783219 -0.0713966 0.0781054 0.0422706 0.0716338 -0.0424701 0.0 +1341 2.95 3.25 153.75 -0.137718 -0.149787 0.137636 0.0630045 0.149918 -0.0630855 0.0 +1342 2.95 3.25 161.25 -0.209697 -0.23746 0.209832 0.0883427 0.237538 -0.0884379 0.0 +1343 2.95 3.25 168.75 -0.275371 -0.313873 0.275402 0.111664 0.314062 -0.111753 0.0 +1344 2.95 3.25 176.25 -0.314348 -0.358242 0.314391 0.125665 0.357993 -0.125515 0.0 +1345 2.95 3.35 3.75 -399.508 103.619 399.508 7451.41 -103.619 -7451.41 0.0 +1346 2.95 3.35 11.25 -231.405 35.127 231.405 3026.44 -35.127 -3026.44 0.0 +1347 2.95 3.35 18.75 -89.8146 -2.33149 89.8146 930.13 2.3315 -930.13 0.0 +1348 2.95 3.35 26.25 -22.0607 -7.1465 22.0607 211.828 7.14652 -211.828 0.0 +1349 2.95 3.35 33.75 -2.61211 -2.84669 2.61203 30.3988 2.84678 -30.3988 0.0 +1350 2.95 3.35 41.25 -0.0641668 -0.572722 0.0641482 1.85321 0.572769 -1.85319 0.0 +1351 2.95 3.35 48.75 -0.0727144 -0.324155 0.0726592 -0.0128306 0.324113 0.0128188 0.0 +1352 2.95 3.35 56.25 -0.0429539 -0.369477 0.0429431 0.0365148 0.369487 -0.0365382 0.0 +1353 2.95 3.35 63.75 -0.0600198 -0.322362 0.0600919 0.0327313 0.322318 -0.0327163 0.0 +1354 2.95 3.35 71.25 -0.0652833 -0.262303 0.0652719 -0.000945077 0.262315 0.000937457 0.0 +1355 2.95 3.35 78.75 -0.031022 -0.194374 0.0309769 -0.0267122 0.194554 0.0267582 0.0 +1356 2.95 3.35 86.25 -0.00184005 -0.113162 0.00176104 -0.0298197 0.113076 0.0298218 0.0 +1357 2.95 3.35 93.75 0.018586 -0.0277066 -0.0184827 -0.0312711 0.0276271 0.0312812 0.0 +1358 2.95 3.35 101.25 0.0371138 0.0478631 -0.037144 -0.0299553 -0.0480008 0.0299616 0.0 +1359 2.95 3.35 108.75 0.0423982 0.093388 -0.0422422 -0.0188882 -0.0933397 0.0188857 0.0 +1360 2.95 3.35 116.25 0.0273758 0.0979945 -0.0273687 -0.00448478 -0.0979721 0.00447213 0.0 +1361 2.95 3.35 123.75 0.00420771 0.0743592 -0.00427898 0.00600864 -0.0745728 -0.0058675 0.0 +1362 2.95 3.35 131.25 -0.0145851 0.0414175 0.0147362 0.0124371 -0.0414414 -0.0124358 0.0 +1363 2.95 3.35 138.75 -0.03007 0.00528296 0.0300369 0.0181261 -0.00525075 -0.018187 0.0 +1364 2.95 3.35 146.25 -0.0509356 -0.0404972 0.0512567 0.0264418 0.040464 -0.0264103 0.0 +1365 2.95 3.35 153.75 -0.0853645 -0.10106 0.0852954 0.0392425 0.100971 -0.0391701 0.0 +1366 2.95 3.35 161.25 -0.129326 -0.170331 0.12924 0.0554642 0.170326 -0.0554588 0.0 +1367 2.95 3.35 168.75 -0.171342 -0.232151 0.171081 0.0709676 0.232288 -0.0710617 0.0 +1368 2.95 3.35 176.25 -0.196671 -0.268622 0.196769 0.0804998 0.268617 -0.0804939 0.0 +1369 2.95 3.45 3.75 -118.47 124.094 118.47 3596.85 -124.094 -3596.85 0.0 +1370 2.95 3.45 11.25 -62.0251 58.1208 62.0251 1612.69 -58.1208 -1612.69 0.0 +1371 2.95 3.45 18.75 -17.2025 11.8124 17.2025 506.519 -11.8125 -506.519 0.0 +1372 2.95 3.45 26.25 -0.377844 -1.71658 0.37789 113.34 1.71654 -113.34 0.0 +1373 2.95 3.45 33.75 1.37632 -1.48954 -1.37633 15.5555 1.4896 -15.5555 0.0 +1374 2.95 3.45 41.25 0.265026 -0.272138 -0.265013 0.865629 0.272128 -0.865594 0.0 +1375 2.95 3.45 48.75 -0.0675124 -0.169675 0.0675642 -0.0146368 0.169647 0.0146363 0.0 +1376 2.95 3.45 56.25 -0.023388 -0.236641 0.0234179 0.015066 0.236607 -0.015018 0.0 +1377 2.95 3.45 63.75 -0.0206674 -0.214642 0.0205493 0.0137967 0.214624 -0.0137863 0.0 +1378 2.95 3.45 71.25 -0.0266153 -0.192791 0.0266153 -0.00202341 0.192818 0.00206841 0.0 +1379 2.95 3.45 78.75 -0.01303 -0.158177 0.0130391 -0.00963045 0.158217 0.00964696 0.0 +1380 2.95 3.45 86.25 -0.00222429 -0.0960735 0.0021395 -0.0105039 0.0961189 0.0105017 0.0 +1381 2.95 3.45 93.75 0.00366176 -0.0280042 -0.00362622 -0.0130186 0.0279556 0.0130227 0.0 +1382 2.95 3.45 101.25 0.0105055 0.0297138 -0.0104632 -0.0119289 -0.0296664 0.0119117 0.0 +1383 2.95 3.45 108.75 0.0148087 0.0656952 -0.0147408 -0.00665645 -0.0657398 0.0066868 0.0 +1384 2.95 3.45 116.25 0.0114932 0.0726041 -0.0116021 -0.00156607 -0.0726457 0.00154858 0.0 +1385 2.95 3.45 123.75 0.00309518 0.0572911 -0.00312058 0.00244903 -0.0572973 -0.00247607 0.0 +1386 2.95 3.45 131.25 -0.00423195 0.0348253 0.00428653 0.0058355 -0.0347892 -0.0058315 0.0 +1387 2.95 3.45 138.75 -0.00866474 0.0124609 0.00861874 0.00825108 -0.0125166 -0.00826851 0.0 +1388 2.95 3.45 146.25 -0.0145607 -0.0144555 0.0146647 0.0107256 0.0144883 -0.0106962 0.0 +1389 2.95 3.45 153.75 -0.0287837 -0.0532811 0.0286297 0.0157047 0.0531415 -0.0156193 0.0 +1390 2.95 3.45 161.25 -0.0515253 -0.102148 0.0515477 0.0240732 0.102183 -0.0241063 0.0 +1391 2.95 3.45 168.75 -0.0767337 -0.148935 0.0767439 0.0334601 0.1489 -0.0334712 0.0 +1392 2.95 3.45 176.25 -0.0932086 -0.17774 0.0931942 0.0396944 0.177763 -0.0397001 0.0 +1393 2.95 3.55 3.75 9.21891 55.9716 -9.21891 1053.07 -55.9716 -1053.07 0.0 +1394 2.95 3.55 11.25 12.0915 26.8507 -12.0915 505.759 -26.8507 -505.759 0.0 +1395 2.95 3.55 18.75 10.5932 5.25111 -10.5932 161.202 -5.25111 -161.202 0.0 +1396 2.95 3.55 26.25 5.832 -0.960922 -5.83198 35.2215 0.960912 -35.2215 0.0 +1397 2.95 3.55 33.75 1.90632 -0.606111 -1.90629 4.63776 0.606103 -4.63776 0.0 +1398 2.95 3.55 41.25 0.243995 0.00564805 -0.243998 0.296232 -0.00567539 -0.296199 0.0 +1399 2.95 3.55 48.75 -0.0591471 -0.00860415 0.0591375 0.0274887 0.00861739 -0.0274844 0.0 +1400 2.95 3.55 56.25 -0.0269926 -0.0691277 0.0269968 0.0114055 0.0691244 -0.0114149 0.0 +1401 2.95 3.55 63.75 -0.00607235 -0.0689444 0.00606736 0.00520628 0.0689476 -0.00519972 0.0 +1402 2.95 3.55 71.25 -0.00320545 -0.0714308 0.00319651 0.00162512 0.0714338 -0.00162543 0.0 +1403 2.95 3.55 78.75 -0.000709974 -0.0611886 0.00068591 -0.000332506 0.0611933 0.00033069 0.0 +1404 2.95 3.55 86.25 -0.00172169 -0.0350745 0.00168824 -0.00153632 0.035038 0.00153626 0.0 +1405 2.95 3.55 93.75 -0.00504304 -0.0114154 0.00501691 -0.001532 0.0114067 0.0015284 0.0 +1406 2.95 3.55 101.25 -0.00419399 0.00690274 0.00423812 -0.00070908 -0.00693605 0.000712363 0.0 +1407 2.95 3.55 108.75 0.00145246 0.0217666 -0.00146955 -0.00136473 -0.0217677 0.00136709 0.0 +1408 2.95 3.55 116.25 0.00646822 0.0283925 -0.00648991 -0.0023095 -0.0283929 0.00231683 0.0 +1409 2.95 3.55 123.75 0.0071676 0.0255024 -0.00717304 -0.00117394 -0.0255343 0.00118872 0.0 +1410 2.95 3.55 131.25 0.00551051 0.0191405 -0.00553503 0.000805702 -0.0191302 -0.000807014 0.0 +1411 2.95 3.55 138.75 0.00491972 0.0139924 -0.00492367 0.00107791 -0.0140157 -0.00107725 0.0 +1412 2.95 3.55 146.25 0.00468329 0.0079675 -0.00466349 9.16014e-06 -0.0079586 -7.70033e-06 0.0 +1413 2.95 3.55 153.75 0.00109992 -0.00389049 -0.00104878 0.000299902 0.00394253 -0.000326509 0.0 +1414 2.95 3.55 161.25 -0.0078958 -0.022461 0.00792024 0.0035239 0.0224411 -0.0035224 0.0 +1415 2.95 3.55 168.75 -0.019444 -0.0423078 0.0194506 0.00839838 0.0423256 -0.00840352 0.0 +1416 2.95 3.55 176.25 -0.0275442 -0.0551633 0.0275625 0.011971 0.0551683 -0.0119705 0.0 +1417 2.95 3.65 3.75 7.06704 4.57331 -7.06704 82.2836 -4.57331 -82.2836 0.0 +1418 2.95 3.65 11.25 5.4451 1.75617 -5.4451 41.4025 -1.75617 -41.4025 0.0 +1419 2.95 3.65 18.75 3.205 -0.181937 -3.205 13.315 0.181936 -13.315 0.0 +1420 2.95 3.65 26.25 1.3884 -0.45091 -1.3884 2.87287 0.450911 -2.87287 0.0 +1421 2.95 3.65 33.75 0.399535 -0.156162 -0.399534 0.408566 0.156164 -0.408568 0.0 +1422 2.95 3.65 41.25 0.0474327 0.000325414 -0.0474365 0.0559439 -0.000322232 -0.0559436 0.0 +1423 2.95 3.65 48.75 -0.0167623 0.0148239 0.0167622 0.0118571 -0.0148242 -0.011857 0.0 +1424 2.95 3.65 56.25 -0.00966538 0.00961204 0.00966566 0.000613902 -0.00961345 -0.000615629 0.0 +1425 2.95 3.65 63.75 -0.0018771 0.00670523 0.00187471 0.000440809 -0.00670146 -0.000440008 0.0 +1426 2.95 3.65 71.25 -0.000281351 0.00228719 0.000284629 0.00150972 -0.00228777 -0.00150899 0.0 +1427 2.95 3.65 78.75 -0.000573671 0.000786642 0.000576419 0.00114584 -0.000789663 -0.00114555 0.0 +1428 2.95 3.65 86.25 -0.00114618 0.000614687 0.00115016 0.000658531 -0.000610215 -0.000658224 0.0 +1429 2.95 3.65 93.75 -0.0014843 -0.00108906 0.00148416 0.000686066 0.00108644 -0.000685896 0.0 +1430 2.95 3.65 101.25 -0.000744824 -0.00226437 0.000742569 0.000394 0.00226277 -0.000394553 0.0 +1431 2.95 3.65 108.75 0.000733179 -0.00144773 -0.000733097 -0.000392875 0.00144773 0.000393178 0.0 +1432 2.95 3.65 116.25 0.00137293 -0.00049035 -0.00137606 -0.000632154 0.000487911 0.000633826 0.0 +1433 2.95 3.65 123.75 0.000493895 -0.000912215 -0.00049636 8.38473e-05 0.000900696 -7.85158e-05 0.0 +1434 2.95 3.65 131.25 -0.000825425 -0.0018564 0.000824058 0.000856545 0.00185558 -0.000856062 0.0 +1435 2.95 3.65 138.75 -0.00108814 -0.00180504 0.00109441 0.000819354 0.00179515 -0.000812508 0.0 +1436 2.95 3.65 146.25 1.93775e-05 -0.000479276 -1.65839e-05 0.000158438 0.000470583 -0.000154836 0.0 +1437 2.95 3.65 153.75 0.00166473 0.00127079 -0.00166242 -0.000315957 -0.00126902 0.00031561 0.0 +1438 2.95 3.65 161.25 0.00284097 0.00252966 -0.00283858 -0.000108367 -0.00252762 0.000107593 0.0 +1439 2.95 3.65 168.75 0.00323364 0.00305014 -0.00322845 0.000583253 -0.00304442 -0.000587227 0.0 +1440 2.95 3.65 176.25 0.00320119 0.00313431 -0.00320683 0.0011639 -0.00314025 -0.00116103 0.0 +1441 3.05 2.55 3.75 -99.8903 -1135.49 99.8903 4481.01 1135.49 -4481.01 0.0 +1442 3.05 2.55 11.25 75.4085 -849.863 -75.4085 2098.79 849.863 -2098.79 0.0 +1443 3.05 2.55 18.75 204.713 -503.811 -204.713 608.899 503.811 -608.899 0.0 +1444 3.05 2.55 26.25 215.712 -235.217 -215.712 55.4596 235.217 -55.4596 0.0 +1445 3.05 2.55 33.75 153.506 -77.04 -153.506 -60.3792 77.04 60.3792 0.0 +1446 3.05 2.55 41.25 82.3413 -6.02578 -82.3413 -46.2127 6.02578 46.2127 0.0 +1447 3.05 2.55 48.75 35.0888 15.3934 -35.0889 -22.0144 -15.3934 22.0144 0.0 +1448 3.05 2.55 56.25 12.4887 16.3495 -12.4887 -10.6162 -16.3495 10.6162 0.0 +1449 3.05 2.55 63.75 3.52861 12.5229 -3.52864 -7.32703 -12.5228 7.32705 0.0 +1450 3.05 2.55 71.25 -0.279629 9.40632 0.279539 -6.91201 -9.40632 6.91201 0.0 +1451 3.05 2.55 78.75 -2.43932 7.24433 2.43937 -6.84166 -7.24431 6.84167 0.0 +1452 3.05 2.55 86.25 -3.82544 5.01507 3.82548 -6.03456 -5.01503 6.03456 0.0 +1453 3.05 2.55 93.75 -4.46445 2.39183 4.46443 -4.45383 -2.39181 4.45382 0.0 +1454 3.05 2.55 101.25 -4.14103 -0.193617 4.14113 -2.7115 0.193643 2.7115 0.0 +1455 3.05 2.55 108.75 -2.68814 -2.24179 2.68814 -1.40298 2.24179 1.40298 0.0 +1456 3.05 2.55 116.25 -0.20595 -3.60299 0.205893 -0.720314 3.60292 0.720318 0.0 +1457 3.05 2.55 123.75 2.91287 -4.4257 -2.91292 -0.508612 4.42572 0.50859 0.0 +1458 3.05 2.55 131.25 6.14079 -4.94039 -6.14081 -0.503212 4.94043 0.503203 0.0 +1459 3.05 2.55 138.75 9.01174 -5.32326 -9.01176 -0.502488 5.32335 0.50246 0.0 +1460 3.05 2.55 146.25 11.2442 -5.66887 -11.2442 -0.418121 5.66881 0.418179 0.0 +1461 3.05 2.55 153.75 12.7662 -6.00759 -12.7662 -0.251267 6.00762 0.251242 0.0 +1462 3.05 2.55 161.25 13.6683 -6.32489 -13.6683 -0.0497353 6.3249 0.0497547 0.0 +1463 3.05 2.55 168.75 14.1224 -6.57903 -14.1224 0.126803 6.57893 -0.12674 0.0 +1464 3.05 2.55 176.25 14.2984 -6.72181 -14.2983 0.228789 6.72185 -0.228792 0.0 +1465 3.05 2.65 3.75 -471.72 -1123.11 471.72 7093.34 1123.11 -7093.34 0.0 +1466 3.05 2.65 11.25 -191.767 -808.934 191.767 3001.82 808.934 -3001.82 0.0 +1467 3.05 2.65 18.75 34.008 -459.915 -34.008 894.175 459.915 -894.175 0.0 +1468 3.05 2.65 26.25 112.955 -208.573 -112.955 151.189 208.573 -151.189 0.0 +1469 3.05 2.65 33.75 94.0738 -71.7327 -94.0737 -21.1677 71.7326 21.1677 0.0 +1470 3.05 2.65 41.25 49.4837 -14.5639 -49.4837 -25.8858 14.5639 25.8858 0.0 +1471 3.05 2.65 48.75 18.1201 2.71873 -18.1201 -10.7579 -2.71874 10.7579 0.0 +1472 3.05 2.65 56.25 4.50067 5.1919 -4.50071 -4.17437 -5.19187 4.17439 0.0 +1473 3.05 2.65 63.75 0.324738 4.12228 -0.324708 -2.7649 -4.12229 2.76489 0.0 +1474 3.05 2.65 71.25 -0.885083 3.14173 0.885105 -2.71919 -3.14167 2.71917 0.0 +1475 3.05 2.65 78.75 -1.47411 2.5775 1.47404 -2.75787 -2.57751 2.75787 0.0 +1476 3.05 2.65 86.25 -1.87152 1.90054 1.8715 -2.4228 -1.90059 2.4228 0.0 +1477 3.05 2.65 93.75 -2.02466 0.923135 2.02473 -1.71585 -0.923116 1.71585 0.0 +1478 3.05 2.65 101.25 -1.76347 -0.106789 1.76345 -0.967378 0.106801 0.967378 0.0 +1479 3.05 2.65 108.75 -0.963999 -0.917273 0.964072 -0.468617 0.917246 0.468634 0.0 +1480 3.05 2.65 116.25 0.320331 -1.45246 -0.320253 -0.271727 1.4525 0.271712 0.0 +1481 3.05 2.65 123.75 1.86745 -1.80964 -1.86754 -0.2599 1.80962 0.259901 0.0 +1482 3.05 2.65 131.25 3.39911 -2.09969 -3.3991 -0.291824 2.0997 0.291795 0.0 +1483 3.05 2.65 138.75 4.68845 -2.3866 -4.68845 -0.280717 2.38662 0.280678 0.0 +1484 3.05 2.65 146.25 5.61507 -2.69242 -5.61523 -0.201921 2.6924 0.201911 0.0 +1485 3.05 2.65 153.75 6.16957 -3.01207 -6.1696 -0.0714668 3.01198 0.0715084 0.0 +1486 3.05 2.65 161.25 6.42631 -3.31783 -6.42636 0.0757921 3.31775 -0.0757403 0.0 +1487 3.05 2.65 168.75 6.50157 -3.56436 -6.50164 0.201289 3.56437 -0.201315 0.0 +1488 3.05 2.65 176.25 6.50603 -3.70329 -6.50603 0.273064 3.70334 -0.273107 0.0 +1489 3.05 2.75 3.75 -819.915 -1054.18 819.915 10801.3 1054.18 -10801.3 0.0 +1490 3.05 2.75 11.25 -428.7 -725.593 428.7 3920.51 725.593 -3920.51 0.0 +1491 3.05 2.75 18.75 -114.05 -391.224 114.05 1152.33 391.224 -1152.33 0.0 +1492 3.05 2.75 26.25 26.6042 -166.507 -26.6042 231.532 166.507 -231.532 0.0 +1493 3.05 2.75 33.75 47.3 -54.4281 -47.3 8.52819 54.4281 -8.52819 0.0 +1494 3.05 2.75 41.25 26.4694 -12.5721 -26.4693 -12.454 12.5721 12.454 0.0 +1495 3.05 2.75 48.75 8.21568 -1.0587 -8.21571 -4.42962 1.05872 4.42958 0.0 +1496 3.05 2.75 56.25 0.933521 0.970656 -0.933436 -1.13308 -0.970672 1.13312 0.0 +1497 3.05 2.75 63.75 -0.591387 0.896497 0.591369 -0.802744 -0.896534 0.80272 0.0 +1498 3.05 2.75 71.25 -0.708852 0.736982 0.708892 -0.888009 -0.736903 0.888014 0.0 +1499 3.05 2.75 78.75 -0.726053 0.759715 0.726002 -0.940145 -0.759774 0.940141 0.0 +1500 3.05 2.75 86.25 -0.765586 0.712852 0.765659 -0.840917 -0.712822 0.840918 0.0 +1501 3.05 2.75 93.75 -0.763361 0.473034 0.763336 -0.584351 -0.473083 0.584352 0.0 +1502 3.05 2.75 101.25 -0.61589 0.159455 0.615896 -0.319598 -0.159469 0.319598 0.0 +1503 3.05 2.75 108.75 -0.25518 -0.0967453 0.255171 -0.166777 0.0969022 0.166722 0.0 +1504 3.05 2.75 116.25 0.285009 -0.28291 -0.284971 -0.126066 0.282912 0.126057 0.0 +1505 3.05 2.75 123.75 0.897522 -0.44854 -0.897517 -0.135093 0.448509 0.135108 0.0 +1506 3.05 2.75 131.25 1.46791 -0.62815 -1.46794 -0.139317 0.628143 0.139325 0.0 +1507 3.05 2.75 138.75 1.9137 -0.829458 -1.91378 -0.113487 0.829399 0.113499 0.0 +1508 3.05 2.75 146.25 2.19463 -1.05152 -2.19449 -0.0541464 1.05163 0.0541151 0.0 +1509 3.05 2.75 153.75 2.31281 -1.28912 -2.31287 0.0298665 1.2892 -0.0299121 0.0 +1510 3.05 2.75 161.25 2.31047 -1.52248 -2.31048 0.121875 1.52245 -0.121854 0.0 +1511 3.05 2.75 168.75 2.2526 -1.71516 -2.25253 0.200736 1.7151 -0.200722 0.0 +1512 3.05 2.75 176.25 2.20364 -1.82546 -2.20366 0.246345 1.82537 -0.246316 0.0 +1513 3.05 2.85 3.75 -1091.5 -924.826 1091.5 15876.4 924.826 -15876.4 0.0 +1514 3.05 2.85 11.25 -600.889 -610.446 600.889 4701.21 610.446 -4701.21 0.0 +1515 3.05 2.85 18.75 -221.774 -313.095 221.774 1347.46 313.095 -1347.46 0.0 +1516 3.05 2.85 26.25 -36.1715 -123.034 36.1715 288.867 123.034 -288.867 0.0 +1517 3.05 2.85 33.75 14.4109 -35.751 -14.4109 28.4156 35.751 -28.4156 0.0 +1518 3.05 2.85 41.25 11.7477 -7.54625 -11.7476 -4.47886 7.54624 4.47889 0.0 +1519 3.05 2.85 48.75 3.02266 -1.2724 -3.02262 -1.36059 1.27242 1.36062 0.0 +1520 3.05 2.85 56.25 -0.293101 -0.234224 0.293102 0.0148782 0.234259 -0.0148768 0.0 +1521 3.05 2.85 63.75 -0.604408 -0.0864725 0.604562 -0.135551 0.0865208 0.135542 0.0 +1522 3.05 2.85 71.25 -0.423986 -0.0183332 0.424026 -0.236452 0.0183536 0.236484 0.0 +1523 3.05 2.85 78.75 -0.3123 0.1248 0.312209 -0.277309 -0.124861 0.277305 0.0 +1524 3.05 2.85 86.25 -0.248721 0.239777 0.248749 -0.273132 -0.2399 0.273128 0.0 +1525 3.05 2.85 93.75 -0.199626 0.248962 0.199561 -0.204975 -0.24897 0.204973 0.0 +1526 3.05 2.85 101.25 -0.120259 0.201191 0.120215 -0.129864 -0.201248 0.129884 0.0 +1527 3.05 2.85 108.75 0.0123537 0.148079 -0.0122872 -0.0877108 -0.14809 0.0877165 0.0 +1528 3.05 2.85 116.25 0.173327 0.0836399 -0.173362 -0.0691073 -0.0836389 0.0691089 0.0 +1529 3.05 2.85 123.75 0.32621 -0.00777206 -0.326258 -0.0543665 0.00767605 0.054391 0.0 +1530 3.05 2.85 131.25 0.449831 -0.119322 -0.449959 -0.0354792 0.119322 0.0354522 0.0 +1531 3.05 2.85 138.75 0.531523 -0.239616 -0.531528 -0.0103697 0.239718 0.0103411 0.0 +1532 3.05 2.85 146.25 0.559126 -0.370369 -0.559031 0.0242302 0.370329 -0.0241818 0.0 +1533 3.05 2.85 153.75 0.528094 -0.517307 -0.52826 0.0705032 0.517171 -0.070455 0.0 +1534 3.05 2.85 161.25 0.453914 -0.672153 -0.453993 0.124135 0.672161 -0.124122 0.0 +1535 3.05 2.85 168.75 0.370253 -0.807261 -0.370135 0.173118 0.807245 -0.173108 0.0 +1536 3.05 2.85 176.25 0.315462 -0.887101 -0.315566 0.202652 0.887107 -0.202673 0.0 +1537 3.05 2.95 3.75 -1232.87 -727.611 1232.87 21705.2 727.611 -21705.2 0.0 +1538 3.05 2.95 11.25 -683.419 -470.91 683.419 5177.91 470.91 -5177.91 0.0 +1539 3.05 2.95 18.75 -278.179 -234.268 278.179 1452.23 234.268 -1452.23 0.0 +1540 3.05 2.95 26.25 -72.0176 -85.4621 72.0176 319.105 85.462 -319.105 0.0 +1541 3.05 2.95 33.75 -5.04395 -21.0669 5.04397 39.4173 21.0669 -39.4173 0.0 +1542 3.05 2.95 41.25 3.48774 -3.28191 -3.48769 -0.300635 3.2819 0.300647 0.0 +1543 3.05 2.95 48.75 0.664886 -0.652039 -0.664789 -0.139738 0.652028 0.139711 0.0 +1544 3.05 2.95 56.25 -0.523616 -0.414034 0.523516 0.306792 0.414075 -0.306796 0.0 +1545 3.05 2.95 63.75 -0.434262 -0.279203 0.434317 0.0328779 0.279155 -0.0328601 0.0 +1546 3.05 2.95 71.25 -0.263989 -0.17845 0.263927 -0.0557287 0.178451 0.0557149 0.0 +1547 3.05 2.95 78.75 -0.155524 -0.0604642 0.155421 -0.0950323 0.0604433 0.0950443 0.0 +1548 3.05 2.95 86.25 -0.067447 0.04758 0.0673218 -0.117252 -0.0475915 0.117248 0.0 +1549 3.05 2.95 93.75 -0.00166102 0.107279 0.00164027 -0.105172 -0.107316 0.105191 0.0 +1550 3.05 2.95 101.25 0.0535862 0.135458 -0.0536877 -0.0832458 -0.135274 0.0832323 0.0 +1551 3.05 2.95 108.75 0.0967651 0.14059 -0.0966865 -0.0609958 -0.14058 0.0609828 0.0 +1552 3.05 2.95 116.25 0.109945 0.110287 -0.109908 -0.0329892 -0.110348 0.033027 0.0 +1553 3.05 2.95 123.75 0.0929853 0.0494498 -0.0930526 -0.0025344 -0.0494806 0.00258764 0.0 +1554 3.05 2.95 131.25 0.0642303 -0.01905 -0.0641238 0.0216847 0.0188441 -0.0215685 0.0 +1555 3.05 2.95 138.75 0.0332905 -0.0834771 -0.0332997 0.03867 0.083467 -0.0386494 0.0 +1556 3.05 2.95 146.25 -0.00878391 -0.154233 0.00888735 0.0564103 0.154439 -0.0564727 0.0 +1557 3.05 2.95 153.75 -0.0746897 -0.245398 0.0746327 0.0831603 0.245496 -0.0832365 0.0 +1558 3.05 2.95 161.25 -0.160201 -0.353255 0.160227 0.119078 0.353605 -0.119288 0.0 +1559 3.05 2.95 168.75 -0.243403 -0.453661 0.243311 0.154918 0.453781 -0.154984 0.0 +1560 3.05 2.95 176.25 -0.294717 -0.514746 0.294773 0.177486 0.51451 -0.177287 0.0 +1561 3.05 3.05 3.75 -1202.39 -470.365 1202.39 24403 470.365 -24403 0.0 +1562 3.05 3.05 11.25 -668.169 -316.378 668.169 5239.8 316.378 -5239.8 0.0 +1563 3.05 3.05 18.75 -281.731 -159.304 281.731 1455.24 159.304 -1455.24 0.0 +1564 3.05 3.05 26.25 -82.2316 -55.9751 82.2316 322.339 55.9751 -322.339 0.0 +1565 3.05 3.05 33.75 -13.2072 -11.7376 13.2072 43.2474 11.7377 -43.2475 0.0 +1566 3.05 3.05 41.25 -0.23727 -0.951403 0.237225 1.56363 0.951413 -1.56361 0.0 +1567 3.05 3.05 48.75 -0.165939 -0.246228 0.165967 0.206541 0.24613 -0.206511 0.0 +1568 3.05 3.05 56.25 -0.436043 -0.410636 0.436083 0.304896 0.410632 -0.304963 0.0 +1569 3.05 3.05 63.75 -0.30763 -0.310295 0.307609 0.0679989 0.310281 -0.0680052 0.0 +1570 3.05 3.05 71.25 -0.206649 -0.205757 0.206684 -0.0143256 0.20578 0.0143312 0.0 +1571 3.05 3.05 78.75 -0.11617 -0.112842 0.116269 -0.0611922 0.112662 0.0611357 0.0 +1572 3.05 3.05 86.25 -0.029379 -0.026893 0.0293335 -0.0825493 0.0270606 0.0825471 0.0 +1573 3.05 3.05 93.75 0.0356369 0.0385347 -0.0355095 -0.077343 -0.0385093 0.0773448 0.0 +1574 3.05 3.05 101.25 0.0825754 0.0864857 -0.0826079 -0.0638125 -0.0866197 0.0638187 0.0 +1575 3.05 3.05 108.75 0.102049 0.105697 -0.102052 -0.0415323 -0.105879 0.0415234 0.0 +1576 3.05 3.05 116.25 0.0810613 0.0846985 -0.0811354 -0.00976694 -0.0847927 0.00982253 0.0 +1577 3.05 3.05 123.75 0.0328587 0.0382796 -0.0327086 0.0205591 -0.0383158 -0.0204996 0.0 +1578 3.05 3.05 131.25 -0.0175676 -0.00884341 0.0174819 0.0399706 0.00881225 -0.0399405 0.0 +1579 3.05 3.05 138.75 -0.0618523 -0.0507538 0.0617807 0.050519 0.0510671 -0.0507029 0.0 +1580 3.05 3.05 146.25 -0.112984 -0.102557 0.112876 0.062213 0.102547 -0.0622186 0.0 +1581 3.05 3.05 153.75 -0.183953 -0.177566 0.184157 0.0833769 0.177745 -0.0834765 0.0 +1582 3.05 3.05 161.25 -0.271208 -0.270479 0.271245 0.113891 0.27054 -0.113888 0.0 +1583 3.05 3.05 168.75 -0.353042 -0.357989 0.353053 0.145016 0.357905 -0.145054 0.0 +1584 3.05 3.05 176.25 -0.402759 -0.411064 0.402707 0.164734 0.411172 -0.164821 0.0 +1585 3.05 3.15 3.75 -1005.86 -194.498 1005.86 20622.3 194.498 -20622.3 0.0 +1586 3.05 3.15 11.25 -566.091 -160.869 566.091 4886.81 160.869 -4886.81 0.0 +1587 3.05 3.15 18.75 -240.287 -91.2699 240.287 1363.35 91.2699 -1363.35 0.0 +1588 3.05 3.15 26.25 -72.1732 -33.8748 72.1732 302.315 33.8748 -302.315 0.0 +1589 3.05 3.15 33.75 -13.3946 -6.76814 13.3946 41.8615 6.76815 -41.8615 0.0 +1590 3.05 3.15 41.25 -1.23842 -0.233142 1.2384 2.17485 0.233108 -2.17487 0.0 +1591 3.05 3.15 48.75 -0.292521 -0.178012 0.292534 0.218004 0.177961 -0.217937 0.0 +1592 3.05 3.15 56.25 -0.284809 -0.428332 0.284868 0.232091 0.428389 -0.232079 0.0 +1593 3.05 3.15 63.75 -0.220727 -0.340585 0.220826 0.0743496 0.340452 -0.0743638 0.0 +1594 3.05 3.15 71.25 -0.169662 -0.229028 0.169575 -0.00422416 0.228937 0.00423996 0.0 +1595 3.05 3.15 78.75 -0.0951492 -0.138864 0.0951079 -0.0524268 0.138897 0.0524133 0.0 +1596 3.05 3.15 86.25 -0.0249568 -0.057734 0.0249618 -0.0648182 0.0578461 0.0648357 0.0 +1597 3.05 3.15 93.75 0.0258392 0.0131362 -0.0256859 -0.0587348 -0.0128765 0.058722 0.0 +1598 3.05 3.15 101.25 0.0643498 0.0683206 -0.0643807 -0.0481836 -0.0685476 0.0481991 0.0 +1599 3.05 3.15 108.75 0.0794928 0.0928215 -0.0794856 -0.02838 -0.0927884 0.0283377 0.0 +1600 3.05 3.15 116.25 0.0621262 0.0783423 -0.0619376 -0.00193475 -0.0783081 0.00196418 0.0 +1601 3.05 3.15 123.75 0.0258006 0.041661 -0.0259602 0.0203971 -0.0415221 -0.0204713 0.0 +1602 3.05 3.15 131.25 -0.00984299 0.0033761 0.0098454 0.0334746 -0.00365493 -0.0333855 0.0 +1603 3.05 3.15 138.75 -0.0442769 -0.0350514 0.0443307 0.0414554 0.0352449 -0.041497 0.0 +1604 3.05 3.15 146.25 -0.091463 -0.0871559 0.0914155 0.052571 0.0871283 -0.0525267 0.0 +1605 3.05 3.15 153.75 -0.160353 -0.160828 0.160224 0.0723048 0.160761 -0.0723438 0.0 +1606 3.05 3.15 161.25 -0.243335 -0.247674 0.243164 0.0993507 0.247967 -0.0995663 0.0 +1607 3.05 3.15 168.75 -0.318898 -0.326134 0.319007 0.126072 0.32627 -0.126173 0.0 +1608 3.05 3.15 176.25 -0.36419 -0.372832 0.36427 0.142724 0.372732 -0.142595 0.0 +1609 3.05 3.25 3.75 -707.917 46.1555 707.917 14705.3 -46.1555 -14705.3 0.0 +1610 3.05 3.25 11.25 -403.239 -21.7092 403.239 4225.41 21.7092 -4225.41 0.0 +1611 3.05 3.25 18.75 -168.322 -33.4945 168.322 1198.15 33.4945 -1198.15 0.0 +1612 3.05 3.25 26.25 -49.4611 -17.619 49.4611 265.09 17.619 -265.09 0.0 +1613 3.05 3.25 33.75 -9.19503 -4.34197 9.19508 37.0193 4.34196 -37.0193 0.0 +1614 3.05 3.25 41.25 -0.984275 -0.283052 0.984305 2.13686 0.283053 -2.13689 0.0 +1615 3.05 3.25 48.75 -0.18842 -0.24192 0.188469 0.12944 0.241853 -0.129426 0.0 +1616 3.05 3.25 56.25 -0.14452 -0.42971 0.144635 0.148393 0.42977 -0.148431 0.0 +1617 3.05 3.25 63.75 -0.142141 -0.341575 0.142225 0.0603106 0.341607 -0.0603114 0.0 +1618 3.05 3.25 71.25 -0.120366 -0.235824 0.120331 -0.00584193 0.236031 0.00590595 0.0 +1619 3.05 3.25 78.75 -0.0648858 -0.155118 0.0648497 -0.0407089 0.155197 0.0406872 0.0 +1620 3.05 3.25 86.25 -0.0170367 -0.0778598 0.0169629 -0.0444295 0.0780579 0.0444343 0.0 +1621 3.05 3.25 93.75 0.0177195 -0.00503444 -0.0176269 -0.0424893 0.00514769 0.042496 0.0 +1622 3.05 3.25 101.25 0.0462891 0.05416 -0.0462865 -0.0373615 -0.0542229 0.0373631 0.0 +1623 3.05 3.25 108.75 0.0573669 0.084333 -0.0573216 -0.0224864 -0.0844456 0.0224838 0.0 +1624 3.05 3.25 116.25 0.0451776 0.0795648 -0.0451227 -0.00389795 -0.0795657 0.00392705 0.0 +1625 3.05 3.25 123.75 0.0215897 0.0526945 -0.021368 0.0103573 -0.0529347 -0.010223 0.0 +1626 3.05 3.25 131.25 -0.00169711 0.0202141 0.00167047 0.0191787 -0.0203379 -0.0191286 0.0 +1627 3.05 3.25 138.75 -0.0264021 -0.0159575 0.0263373 0.0263274 0.0160538 -0.0263645 0.0 +1628 3.05 3.25 146.25 -0.0639974 -0.0644796 0.063985 0.0366322 0.0642138 -0.0364741 0.0 +1629 3.05 3.25 153.75 -0.119886 -0.129575 0.119896 0.0530471 0.129703 -0.0531036 0.0 +1630 3.05 3.25 161.25 -0.186549 -0.203618 0.186351 0.0742664 0.20364 -0.0742798 0.0 +1631 3.05 3.25 168.75 -0.246276 -0.269152 0.246288 0.0946959 0.269294 -0.0948405 0.0 +1632 3.05 3.25 176.25 -0.281602 -0.307458 0.281688 0.107277 0.307531 -0.107285 0.0 +1633 3.05 3.35 3.75 -365.113 209.441 365.113 9554.04 -209.441 -9554.04 0.0 +1634 3.05 3.35 11.25 -204.246 81.0767 204.246 3280.1 -81.0766 -3280.1 0.0 +1635 3.05 3.35 18.75 -79.3542 9.6114 79.3542 951.267 -9.61141 -951.267 0.0 +1636 3.05 3.35 26.25 -20.8335 -5.94072 20.8335 209.249 5.9407 -209.249 0.0 +1637 3.05 3.35 33.75 -3.39742 -2.81825 3.39744 28.9771 2.81824 -28.9771 0.0 +1638 3.05 3.35 41.25 -0.403877 -0.37604 0.403872 1.67216 0.375997 -1.67217 0.0 +1639 3.05 3.35 48.75 -0.0863015 -0.268756 0.0862503 0.0304183 0.2687 -0.0303612 0.0 +1640 3.05 3.35 56.25 -0.0467076 -0.385723 0.0467254 0.0764897 0.385756 -0.0765678 0.0 +1641 3.05 3.35 63.75 -0.0765137 -0.296157 0.076492 0.0332949 0.296254 -0.033302 0.0 +1642 3.05 3.35 71.25 -0.0737102 -0.217777 0.0736319 -0.011919 0.217711 0.0118976 0.0 +1643 3.05 3.35 78.75 -0.0386226 -0.164005 0.0385937 -0.0252131 0.164091 0.0252167 0.0 +1644 3.05 3.35 86.25 -0.00860859 -0.0968502 0.00848829 -0.0245854 0.0969682 0.0245984 0.0 +1645 3.05 3.35 93.75 0.0147737 -0.0236231 -0.0147163 -0.0288229 0.0237517 0.0288162 0.0 +1646 3.05 3.35 101.25 0.0330742 0.0394288 -0.0329504 -0.0272844 -0.0394857 0.0273121 0.0 +1647 3.05 3.35 108.75 0.0377886 0.0770313 -0.0378089 -0.0166062 -0.0771797 0.0166531 0.0 +1648 3.05 3.35 116.25 0.0269164 0.0808568 -0.0269524 -0.00526022 -0.0808528 0.00523792 0.0 +1649 3.05 3.35 123.75 0.00994602 0.0605897 -0.00992017 0.00301009 -0.06072 -0.00291031 0.0 +1650 3.05 3.35 131.25 -0.00533206 0.0321631 0.00513532 0.00937287 -0.0322053 -0.00941624 0.0 +1651 3.05 3.35 138.75 -0.0198079 0.00170782 0.0198683 0.0152825 -0.00186433 -0.0152538 0.0 +1652 3.05 3.35 146.25 -0.0421542 -0.0369206 0.0421364 0.0228346 0.0366588 -0.0227076 0.0 +1653 3.05 3.35 153.75 -0.0772172 -0.0895244 0.0772434 0.0344402 0.0896002 -0.0344561 0.0 +1654 3.05 3.35 161.25 -0.121604 -0.151599 0.12161 0.0498996 0.151602 -0.0499331 0.0 +1655 3.05 3.35 168.75 -0.163376 -0.208149 0.163288 0.0652244 0.208133 -0.0652161 0.0 +1656 3.05 3.35 176.25 -0.188553 -0.242014 0.18862 0.0748184 0.241996 -0.0748296 0.0 +1657 3.05 3.45 3.75 -49.0063 211.636 49.0063 4534.02 -211.636 -4534.02 0.0 +1658 3.05 3.45 11.25 -16.2879 99.9048 16.2879 1783.56 -99.9048 -1783.56 0.0 +1659 3.05 3.45 18.75 1.92371 24.1588 -1.92369 528.913 -24.1588 -528.913 0.0 +1660 3.05 3.45 26.25 3.92081 0.239734 -3.92085 114.895 -0.239708 -114.895 0.0 +1661 3.05 3.45 33.75 1.33681 -1.29813 -1.33683 15.4468 1.29814 -15.4467 0.0 +1662 3.05 3.45 41.25 0.0515692 -0.168192 -0.0515773 0.808296 0.168187 -0.808324 0.0 +1663 3.05 3.45 48.75 -0.0454932 -0.172325 0.0455576 -0.0119284 0.172203 0.0119136 0.0 +1664 3.05 3.45 56.25 -0.00725921 -0.261217 0.00720111 0.0402311 0.261254 -0.040187 0.0 +1665 3.05 3.45 63.75 -0.0304125 -0.195611 0.0304302 0.0163773 0.195633 -0.0163835 0.0 +1666 3.05 3.45 71.25 -0.0332991 -0.159008 0.0333114 -0.00806962 0.159016 0.00804613 0.0 +1667 3.05 3.45 78.75 -0.0178735 -0.133654 0.0179131 -0.00824974 0.13361 0.00825353 0.0 +1668 3.05 3.45 86.25 -0.00502976 -0.0823886 0.00511234 -0.00794398 0.0823682 0.00794143 0.0 +1669 3.05 3.45 93.75 0.00414406 -0.0240697 -0.00419551 -0.0119802 0.0240974 0.0119811 0.0 +1670 3.05 3.45 101.25 0.0110567 0.0255518 -0.0111244 -0.0104323 -0.025573 0.0104402 0.0 +1671 3.05 3.45 108.75 0.0138462 0.0574772 -0.013883 -0.00606324 -0.0575893 0.00608259 0.0 +1672 3.05 3.45 116.25 0.011077 0.0635865 -0.0110606 -0.00305434 -0.0635874 0.00307944 0.0 +1673 3.05 3.45 123.75 0.00449426 0.0488256 -0.00448388 0.000439858 -0.0487677 -0.000429246 0.0 +1674 3.05 3.45 131.25 -0.0019067 0.0282409 0.0019165 0.0047807 -0.028183 -0.00479583 0.0 +1675 3.05 3.45 138.75 -0.00725526 0.00817585 0.0071253 0.00823976 -0.0082291 -0.00826636 0.0 +1676 3.05 3.45 146.25 -0.0164527 -0.017166 0.0163605 0.0119186 0.0170814 -0.0118721 0.0 +1677 3.05 3.45 153.75 -0.0355769 -0.0560084 0.0355731 0.0191433 0.0558956 -0.0190579 0.0 +1678 3.05 3.45 161.25 -0.0646594 -0.106219 0.0647645 0.0307881 0.106203 -0.0308022 0.0 +1679 3.05 3.45 168.75 -0.0953586 -0.154516 0.0954731 0.0434057 0.154565 -0.0434184 0.0 +1680 3.05 3.45 176.25 -0.115325 -0.184291 0.11528 0.0516029 0.184203 -0.0515372 0.0 +1681 3.05 3.55 3.75 58.2865 95.694 -58.2865 1303.18 -95.694 -1303.18 0.0 +1682 3.05 3.55 11.25 43.7842 47.0725 -43.7842 564.702 -47.0725 -564.702 0.0 +1683 3.05 3.55 18.75 24.1468 11.6001 -24.1468 170.104 -11.6002 -170.104 0.0 +1684 3.05 3.55 26.25 9.2032 0.165595 -9.2032 36.0656 -0.165608 -36.0656 0.0 +1685 3.05 3.55 33.75 2.10018 -0.495089 -2.10018 4.59251 0.495098 -4.5925 0.0 +1686 3.05 3.55 41.25 0.159888 0.0314295 -0.159875 0.213805 -0.0314347 -0.213825 0.0 +1687 3.05 3.55 48.75 -0.0316332 -0.0209589 0.0316297 0.0113881 0.020965 -0.011392 0.0 +1688 3.05 3.55 56.25 -0.00590874 -0.08247 0.00589294 0.029912 0.0824799 -0.0299018 0.0 +1689 3.05 3.55 63.75 -0.00460387 -0.0639712 0.00458972 0.0134455 0.0639916 -0.0134371 0.0 +1690 3.05 3.55 71.25 -0.00323754 -0.0605657 0.00327371 0.00123371 0.0605309 -0.00124148 0.0 +1691 3.05 3.55 78.75 -0.000975075 -0.0526099 0.000959984 0.00021812 0.052629 -0.000218025 0.0 +1692 3.05 3.55 86.25 -0.00152766 -0.0304211 0.00152531 -0.000124893 0.0304344 0.000128979 0.0 +1693 3.05 3.55 93.75 -0.00281045 -0.0103052 0.00282543 -0.000164696 0.0103138 0.000165631 0.0 +1694 3.05 3.55 101.25 -0.000794283 0.00655645 0.00082915 9.05452e-05 -0.0065146 -9.18973e-05 0.0 +1695 3.05 3.55 108.75 0.0048571 0.0208882 -0.00483972 -0.00172205 -0.020898 0.00171912 0.0 +1696 3.05 3.55 116.25 0.00910593 0.0261263 -0.00910381 -0.00286916 -0.026165 0.00289949 0.0 +1697 3.05 3.55 123.75 0.00835341 0.0213906 -0.00837047 -0.000577344 -0.0213633 0.000556754 0.0 +1698 3.05 3.55 131.25 0.00484672 0.0140179 -0.00483896 0.00261085 -0.0140112 -0.00259889 0.0 +1699 3.05 3.55 138.75 0.00145793 0.00803444 -0.00146708 0.00365082 -0.00802698 -0.00365445 0.0 +1700 3.05 3.55 146.25 -0.00319952 -0.000185068 0.00323208 0.00391313 0.000156672 -0.00387595 0.0 +1701 3.05 3.55 153.75 -0.0136071 -0.0160629 0.0136006 0.0069895 0.0160638 -0.00699597 0.0 +1702 3.05 3.55 161.25 -0.0307544 -0.0391932 0.0307909 0.0140586 0.0392269 -0.0140635 0.0 +1703 3.05 3.55 168.75 -0.0498663 -0.0628118 0.0498782 0.0225481 0.0628021 -0.0225421 0.0 +1704 3.05 3.55 176.25 -0.0625385 -0.0776921 0.0625437 0.0282624 0.0776849 -0.0282597 0.0 +1705 3.05 3.65 3.75 14.7738 9.01288 -14.7738 99.4234 -9.01288 -99.4234 0.0 +1706 3.05 3.65 11.25 10.4256 4.10096 -10.4256 45.9297 -4.10096 -45.9297 0.0 +1707 3.05 3.65 18.75 5.33829 0.564282 -5.33829 13.8766 -0.564281 -13.8766 0.0 +1708 3.05 3.65 26.25 1.92055 -0.318539 -1.92055 2.83407 0.318537 -2.83407 0.0 +1709 3.05 3.65 33.75 0.431842 -0.140656 -0.431843 0.348739 0.140656 -0.348739 0.0 +1710 3.05 3.65 41.25 0.0364247 0.00723669 -0.0364242 0.0264389 -0.00723644 -0.0264393 0.0 +1711 3.05 3.65 48.75 -0.0100345 0.0159315 0.0100318 0.0080024 -0.0159293 -0.00800035 0.0 +1712 3.05 3.65 56.25 -0.00452025 0.00778732 0.00451941 0.00551883 -0.00778686 -0.00552083 0.0 +1713 3.05 3.65 63.75 -0.000672337 0.00521555 0.000670408 0.00280248 -0.00521397 -0.00280318 0.0 +1714 3.05 3.65 71.25 0.000360923 0.00171355 -0.00036216 0.00121365 -0.00171269 -0.00121435 0.0 +1715 3.05 3.65 78.75 6.70805e-05 0.000819412 -6.59271e-05 0.000597606 -0.000817676 -0.000597435 0.0 +1716 3.05 3.65 86.25 -0.00057186 0.000644185 0.000572355 0.000567504 -0.00064307 -0.000567647 0.0 +1717 3.05 3.65 93.75 -0.000751471 -0.00106817 0.000749874 0.000757072 0.00106639 -0.000757055 0.0 +1718 3.05 3.65 101.25 0.000275919 -0.00183009 -0.000275096 0.000255174 0.00183474 -0.00025562 0.0 +1719 3.05 3.65 108.75 0.00189848 -0.000761837 -0.00189497 -0.000636546 0.000759074 0.000637236 0.0 +1720 3.05 3.65 116.25 0.00236351 -0.000115402 -0.00236272 -0.000553323 0.000119324 0.000553044 0.0 +1721 3.05 3.65 123.75 0.00106135 -0.00107726 -0.00106142 0.000592741 0.00108013 -0.000595129 0.0 +1722 3.05 3.65 131.25 -0.000675214 -0.0023987 0.000676951 0.00145629 0.00239971 -0.00145617 0.0 +1723 3.05 3.65 138.75 -0.00134281 -0.00270273 0.00134522 0.00120903 0.00269853 -0.00120659 0.0 +1724 3.05 3.65 146.25 -0.000900174 -0.00203273 0.000901187 0.000435489 0.00203583 -0.00043519 0.0 +1725 3.05 3.65 153.75 -0.000477871 -0.00132233 0.00047692 0.000219008 0.00131769 -0.000216421 0.0 +1726 3.05 3.65 161.25 -0.000970611 -0.00119912 0.000968838 0.000989395 0.00120357 -0.000993014 0.0 +1727 3.05 3.65 168.75 -0.00221265 -0.00158211 0.00221741 0.00227827 0.00158658 -0.00228145 0.0 +1728 3.05 3.65 176.25 -0.00325813 -0.00197769 0.00326165 0.00322864 0.00198236 -0.00323014 0.0 +1729 3.15 2.55 3.75 -27.4076 -1177.54 27.4076 2986.48 1177.54 -2986.48 0.0 +1730 3.15 2.55 11.25 114.909 -893.434 -114.909 1451.97 893.434 -1451.97 0.0 +1731 3.15 2.55 18.75 220.927 -531.426 -220.927 381.487 531.426 -381.487 0.0 +1732 3.15 2.55 26.25 220.034 -241.118 -220.034 -14.948 241.118 14.948 0.0 +1733 3.15 2.55 33.75 151.765 -67.0502 -151.765 -77.8707 67.0502 77.8707 0.0 +1734 3.15 2.55 41.25 77.6615 10.845 -77.6615 -49.9303 -10.845 49.9303 0.0 +1735 3.15 2.55 48.75 29.4755 32.5379 -29.4755 -24.2324 -32.5379 24.2323 0.0 +1736 3.15 2.55 56.25 7.15336 31.0306 -7.15333 -14.0732 -31.0306 14.0732 0.0 +1737 3.15 2.55 63.75 -1.05485 24.6005 1.05486 -12.17 -24.6005 12.17 0.0 +1738 3.15 2.55 71.25 -4.2524 19.4264 4.25245 -12.4357 -19.4264 12.4357 0.0 +1739 3.15 2.55 78.75 -6.26403 15.3863 6.26407 -11.9586 -15.3863 11.9586 0.0 +1740 3.15 2.55 86.25 -7.82419 11.1006 7.82418 -9.89676 -11.1007 9.89676 0.0 +1741 3.15 2.55 93.75 -8.44213 6.27427 8.44211 -6.88922 -6.27428 6.88922 0.0 +1742 3.15 2.55 101.25 -7.38509 1.54713 7.38513 -4.12212 -1.54706 4.12211 0.0 +1743 3.15 2.55 108.75 -4.32105 -2.46579 4.32104 -2.35334 2.46578 2.35333 0.0 +1744 3.15 2.55 116.25 0.406533 -5.63185 -0.406541 -1.60535 5.63179 1.60537 0.0 +1745 3.15 2.55 123.75 5.96181 -8.14327 -5.96181 -1.46219 8.14332 1.46217 0.0 +1746 3.15 2.55 131.25 11.4239 -10.2167 -11.4239 -1.47786 10.2167 1.47787 0.0 +1747 3.15 2.55 138.75 16.1105 -11.9601 -16.1106 -1.38993 11.9601 1.38992 0.0 +1748 3.15 2.55 146.25 19.6942 -13.3963 -19.6941 -1.1318 13.3963 1.13184 0.0 +1749 3.15 2.55 153.75 22.1564 -14.525 -22.1565 -0.756739 14.525 0.756719 0.0 +1750 3.15 2.55 161.25 23.6733 -15.3528 -23.6732 -0.361675 15.3528 0.361658 0.0 +1751 3.15 2.55 168.75 24.4933 -15.8939 -24.4933 -0.0403958 15.894 0.0403855 0.0 +1752 3.15 2.55 176.25 24.8391 -16.1612 -24.8391 0.138146 16.1611 -0.13812 0.0 +1753 3.15 2.65 3.75 -382.3 -1173.57 382.3 4819.79 1173.57 -4819.79 0.0 +1754 3.15 2.65 11.25 -147.278 -867.4 147.278 2217.25 867.401 -2217.25 0.0 +1755 3.15 2.65 18.75 53.0495 -503.218 -53.0495 646.011 503.218 -646.011 0.0 +1756 3.15 2.65 26.25 120.505 -229.082 -120.505 79.9388 229.082 -79.9388 0.0 +1757 3.15 2.65 33.75 95.7401 -74.5765 -95.7401 -36.4567 74.5765 36.4568 0.0 +1758 3.15 2.65 41.25 47.9555 -8.51743 -47.9555 -27.788 8.51743 27.788 0.0 +1759 3.15 2.65 48.75 15.3087 10.8882 -15.3087 -11.5215 -10.8882 11.5215 0.0 +1760 3.15 2.65 56.25 1.71235 12.3958 -1.71239 -5.88678 -12.3958 5.88679 0.0 +1761 3.15 2.65 63.75 -1.85784 9.95377 1.85788 -5.32284 -9.95375 5.32283 0.0 +1762 3.15 2.65 71.25 -2.5107 8.07183 2.51069 -5.66042 -8.0718 5.66043 0.0 +1763 3.15 2.65 78.75 -2.93298 6.81901 2.93306 -5.45184 -6.81897 5.45184 0.0 +1764 3.15 2.65 86.25 -3.48826 5.29061 3.48826 -4.3935 -5.29062 4.3935 0.0 +1765 3.15 2.65 93.75 -3.74316 3.25676 3.74317 -2.91544 -3.25679 2.91544 0.0 +1766 3.15 2.65 101.25 -3.14313 1.11525 3.14314 -1.68737 -1.11521 1.68737 0.0 +1767 3.15 2.65 108.75 -1.44888 -0.762392 1.44888 -1.05333 0.762401 1.05332 0.0 +1768 3.15 2.65 116.25 1.10632 -2.32234 -1.10636 -0.915764 2.32235 0.915769 0.0 +1769 3.15 2.65 123.75 3.999 -3.68327 -3.99905 -0.981961 3.68328 0.981933 0.0 +1770 3.15 2.65 131.25 6.71067 -4.9306 -6.71071 -1.01292 4.93052 1.01295 0.0 +1771 3.15 2.65 138.75 8.90941 -6.06124 -8.90948 -0.909875 6.06128 0.909848 0.0 +1772 3.15 2.65 146.25 10.478 -7.033 -10.478 -0.682663 7.03303 0.682641 0.0 +1773 3.15 2.65 153.75 11.4595 -7.81473 -11.4594 -0.390365 7.81474 0.390393 0.0 +1774 3.15 2.65 161.25 11.9866 -8.3981 -11.9866 -0.100784 8.39817 0.100743 0.0 +1775 3.15 2.65 168.75 12.2197 -8.78538 -12.2197 0.127706 8.78545 -0.127755 0.0 +1776 3.15 2.65 176.25 12.2968 -8.97894 -12.2968 0.253018 8.97893 -0.253004 0.0 +1777 3.15 2.75 3.75 -717.305 -1099.48 717.305 7349.12 1099.48 -7349.12 0.0 +1778 3.15 2.75 11.25 -384.145 -785.693 384.145 3043.13 785.693 -3043.13 0.0 +1779 3.15 2.75 18.75 -94.9682 -438.11 94.9682 898.217 438.11 -898.217 0.0 +1780 3.15 2.75 26.25 35.5855 -192.065 -35.5856 161.966 192.065 -161.966 0.0 +1781 3.15 2.75 33.75 51.0314 -63.115 -51.0314 -5.03306 63.115 5.03305 0.0 +1782 3.15 2.75 41.25 26.9766 -12.3012 -26.9766 -13.3863 12.3012 13.3863 0.0 +1783 3.15 2.75 48.75 7.19477 2.0083 -7.19476 -4.51753 -2.00835 4.51753 0.0 +1784 3.15 2.75 56.25 -0.300499 3.91871 0.300449 -1.9416 -3.91867 1.94161 0.0 +1785 3.15 2.75 63.75 -1.41191 3.2192 1.41193 -2.06438 -3.2192 2.06437 0.0 +1786 3.15 2.75 71.25 -1.09862 2.77961 1.09861 -2.31409 -2.77961 2.31408 0.0 +1787 3.15 2.75 78.75 -0.97934 2.69801 0.979376 -2.21566 -2.69799 2.21565 0.0 +1788 3.15 2.75 86.25 -1.14939 2.40786 1.14941 -1.73719 -2.40788 1.73719 0.0 +1789 3.15 2.75 93.75 -1.28476 1.7366 1.28478 -1.11459 -1.73658 1.11459 0.0 +1790 3.15 2.75 101.25 -1.02518 0.915603 1.02513 -0.67205 -0.915604 0.67204 0.0 +1791 3.15 2.75 108.75 -0.235222 0.152271 0.235251 -0.525599 -0.152295 0.52559 0.0 +1792 3.15 2.75 116.25 0.926335 -0.543285 -0.92633 -0.564825 0.54314 0.56486 0.0 +1793 3.15 2.75 123.75 2.16828 -1.23531 -2.16834 -0.624796 1.23529 0.624801 0.0 +1794 3.15 2.75 131.25 3.25208 -1.93488 -3.25213 -0.609967 1.93479 0.609996 0.0 +1795 3.15 2.75 138.75 4.06218 -2.59574 -4.06216 -0.506014 2.5958 0.506003 0.0 +1796 3.15 2.75 146.25 4.58223 -3.16844 -4.58219 -0.340482 3.16849 0.340441 0.0 +1797 3.15 2.75 153.75 4.85345 -3.63009 -4.85355 -0.150086 3.63016 0.150049 0.0 +1798 3.15 2.75 161.25 4.94755 -3.97851 -4.9476 0.031051 3.97843 -0.0310191 0.0 +1799 3.15 2.75 168.75 4.94687 -4.2147 -4.94688 0.172789 4.21474 -0.172809 0.0 +1800 3.15 2.75 176.25 4.92478 -4.33518 -4.92479 0.250736 4.33503 -0.250683 0.0 +1801 3.15 2.85 3.75 -983.407 -958.469 983.407 10771.7 958.469 -10771.7 0.0 +1802 3.15 2.85 11.25 -561.262 -663.174 561.262 3820.65 663.174 -3820.65 0.0 +1803 3.15 2.85 18.75 -205.213 -355.243 205.213 1105.74 355.243 -1105.74 0.0 +1804 3.15 2.85 26.25 -27.6167 -147.063 27.6167 223.87 147.063 -223.87 0.0 +1805 3.15 2.85 33.75 18.7771 -45.3665 -18.7771 16.2432 45.3665 -16.2432 0.0 +1806 3.15 2.85 41.25 13.1994 -9.43272 -13.1993 -5.05834 9.43266 5.05833 0.0 +1807 3.15 2.85 48.75 2.91908 -0.530057 -2.9191 -1.2319 0.530074 1.23189 0.0 +1808 3.15 2.85 56.25 -0.745478 0.739328 0.745498 -0.367498 -0.73929 0.367529 0.0 +1809 3.15 2.85 63.75 -0.81633 0.642883 0.816313 -0.716454 -0.6429 0.716445 0.0 +1810 3.15 2.85 71.25 -0.349638 0.675056 0.349664 -0.850932 -0.675061 0.850935 0.0 +1811 3.15 2.85 78.75 -0.149673 0.893423 0.149656 -0.801893 -0.893408 0.80189 0.0 +1812 3.15 2.85 86.25 -0.178712 0.982033 0.178685 -0.62163 -0.982034 0.621621 0.0 +1813 3.15 2.85 93.75 -0.242997 0.836119 0.242971 -0.408167 -0.836147 0.408172 0.0 +1814 3.15 2.85 101.25 -0.148846 0.585948 0.148786 -0.292887 -0.586035 0.292911 0.0 +1815 3.15 2.85 108.75 0.15606 0.331721 -0.155971 -0.293195 -0.331795 0.293195 0.0 +1816 3.15 2.85 116.25 0.567422 0.0594929 -0.567484 -0.331987 -0.0594022 0.331944 0.0 +1817 3.15 2.85 123.75 0.950702 -0.26038 -0.950731 -0.339941 0.260353 0.33994 0.0 +1818 3.15 2.85 131.25 1.23582 -0.606832 -1.23578 -0.298798 0.60675 0.298849 0.0 +1819 3.15 2.85 138.75 1.41461 -0.932834 -1.4147 -0.222025 0.932801 0.222074 0.0 +1820 3.15 2.85 146.25 1.50107 -1.20911 -1.50116 -0.126578 1.20906 0.1266 0.0 +1821 3.15 2.85 153.75 1.51127 -1.43277 -1.51127 -0.0238121 1.43294 0.0237802 0.0 +1822 3.15 2.85 161.25 1.46794 -1.61001 -1.46801 0.0755362 1.60995 -0.0755328 0.0 +1823 3.15 2.85 168.75 1.40576 -1.73855 -1.40577 0.156592 1.73865 -0.156591 0.0 +1824 3.15 2.85 176.25 1.36216 -1.80797 -1.36229 0.202726 1.80777 -0.202612 0.0 +1825 3.15 2.95 3.75 -1133.1 -747.847 1133.1 15204 747.847 -15204 0.0 +1826 3.15 2.95 11.25 -651.39 -510.215 651.39 4410.35 510.215 -4410.35 0.0 +1827 3.15 2.95 18.75 -265.384 -267.084 265.384 1240.36 267.084 -1240.36 0.0 +1828 3.15 2.95 26.25 -65.2059 -104.595 65.2059 261.401 104.595 -261.401 0.0 +1829 3.15 2.95 33.75 -1.1926 -29.0236 1.19257 28.5192 29.0237 -28.5193 0.0 +1830 3.15 2.95 41.25 5.04407 -5.31881 -5.04405 -0.879049 5.31877 0.879106 0.0 +1831 3.15 2.95 48.75 0.8753 -0.662049 -0.875315 -0.00872159 0.662128 0.00871009 0.0 +1832 3.15 2.95 56.25 -0.675197 -0.139671 0.675175 0.120631 0.13964 -0.120625 0.0 +1833 3.15 2.95 63.75 -0.46544 -0.0874773 0.465367 -0.212443 0.0874908 0.212434 0.0 +1834 3.15 2.95 71.25 -0.134062 0.0228327 0.133943 -0.278094 -0.0228418 0.278081 0.0 +1835 3.15 2.95 78.75 0.0168447 0.202657 -0.0168125 -0.266574 -0.202643 0.266593 0.0 +1836 3.15 2.95 86.25 0.0503193 0.315249 -0.0504007 -0.219306 -0.315241 0.219299 0.0 +1837 3.15 2.95 93.75 0.0502706 0.316426 -0.050226 -0.163651 -0.316425 0.163654 0.0 +1838 3.15 2.95 101.25 0.0985225 0.273347 -0.0985613 -0.146427 -0.273435 0.146416 0.0 +1839 3.15 2.95 108.75 0.199999 0.219778 -0.200098 -0.158023 -0.219778 0.157999 0.0 +1840 3.15 2.95 116.25 0.291735 0.132266 -0.291722 -0.160235 -0.132314 0.160262 0.0 +1841 3.15 2.95 123.75 0.329285 0.00185382 -0.329175 -0.137448 -0.00180331 0.13745 0.0 +1842 3.15 2.95 131.25 0.321385 -0.143622 -0.32142 -0.0993839 0.143295 0.0995188 0.0 +1843 3.15 2.95 138.75 0.294709 -0.273448 -0.294757 -0.0582161 0.273501 0.0581947 0.0 +1844 3.15 2.95 146.25 0.258238 -0.381886 -0.258155 -0.0155935 0.381841 0.0156253 0.0 +1845 3.15 2.95 153.75 0.205735 -0.479784 -0.205679 0.0327166 0.479841 -0.0327496 0.0 +1846 3.15 2.95 161.25 0.136947 -0.573355 -0.136947 0.0862248 0.573448 -0.0862026 0.0 +1847 3.15 2.95 168.75 0.0680279 -0.653564 -0.0680505 0.135147 0.653578 -0.135158 0.0 +1848 3.15 2.95 176.25 0.0243153 -0.701137 -0.024347 0.164886 0.701089 -0.164896 0.0 +1849 3.15 3.05 3.75 -1128.81 -471.423 1128.81 19895.2 471.423 -19895.2 0.0 +1850 3.15 3.05 11.25 -641.984 -337.183 641.984 4682.14 337.183 -4682.14 0.0 +1851 3.15 3.05 18.75 -271.929 -180.723 271.929 1285.25 180.723 -1285.25 0.0 +1852 3.15 3.05 26.25 -77.5442 -69.2222 77.5442 273.985 69.2222 -273.985 0.0 +1853 3.15 3.05 33.75 -10.5076 -17.2305 10.5076 33.7556 17.2305 -33.7556 0.0 +1854 3.15 3.05 41.25 0.942208 -2.36919 -0.94215 0.890868 2.36915 -0.890877 0.0 +1855 3.15 3.05 48.75 0.0413467 -0.341702 -0.0413853 0.284244 0.341717 -0.284258 0.0 +1856 3.15 3.05 56.25 -0.512539 -0.300118 0.512514 0.221017 0.300055 -0.221053 0.0 +1857 3.15 3.05 63.75 -0.326838 -0.225898 0.326884 -0.0197921 0.225764 0.019847 0.0 +1858 3.15 3.05 71.25 -0.151039 -0.130692 0.151122 -0.0702483 0.130597 0.0702255 0.0 +1859 3.15 3.05 78.75 -0.0510117 -0.0313348 0.0509675 -0.0903598 0.0314037 0.0903852 0.0 +1860 3.15 3.05 86.25 0.0100222 0.0417384 -0.00996435 -0.0903162 -0.0416107 0.090323 0.0 +1861 3.15 3.05 93.75 0.0505204 0.0773802 -0.050533 -0.0784695 -0.0774641 0.0784768 0.0 +1862 3.15 3.05 101.25 0.0974621 0.100727 -0.0974267 -0.0743341 -0.100721 0.0743344 0.0 +1863 3.15 3.05 108.75 0.138649 0.111398 -0.138664 -0.0691871 -0.111313 0.06919 0.0 +1864 3.15 3.05 116.25 0.139119 0.0890717 -0.139004 -0.0513441 -0.089038 0.0513577 0.0 +1865 3.15 3.05 123.75 0.0947612 0.0372026 -0.0948916 -0.0254731 -0.0372875 0.0254522 0.0 +1866 3.15 3.05 131.25 0.0352216 -0.0199093 -0.0352501 -0.0029018 0.0197286 0.003042 0.0 +1867 3.15 3.05 138.75 -0.0170544 -0.0691083 0.0169796 0.0128318 0.0690801 -0.0128405 0.0 +1868 3.15 3.05 146.25 -0.0650118 -0.117582 0.0649726 0.0284301 0.117519 -0.0283881 0.0 +1869 3.15 3.05 153.75 -0.123114 -0.17842 0.123091 0.0525561 0.178429 -0.0526076 0.0 +1870 3.15 3.05 161.25 -0.194145 -0.252323 0.194335 0.0863865 0.252507 -0.0864426 0.0 +1871 3.15 3.05 168.75 -0.263497 -0.323299 0.263507 0.121102 0.323227 -0.121095 0.0 +1872 3.15 3.05 176.25 -0.306581 -0.367138 0.306588 0.143278 0.367034 -0.143215 0.0 +1873 3.15 3.15 3.75 -956.411 -157.961 956.411 21490.2 157.961 -21490.2 0.0 +1874 3.15 3.15 11.25 -539.133 -158.376 539.133 4570.6 158.376 -4570.6 0.0 +1875 3.15 3.15 18.75 -230.746 -100.448 230.746 1239.08 100.448 -1239.08 0.0 +1876 3.15 3.15 26.25 -69.0286 -41.453 69.0285 264.322 41.4531 -264.322 0.0 +1877 3.15 3.15 33.75 -11.9443 -9.95787 11.9443 34.0693 9.95793 -34.0693 0.0 +1878 3.15 3.15 41.25 -0.582646 -0.953585 0.58261 1.49815 0.953585 -1.49815 0.0 +1879 3.15 3.15 48.75 -0.185725 -0.189058 0.185672 0.262739 0.188971 -0.262688 0.0 +1880 3.15 3.15 56.25 -0.35028 -0.339487 0.350287 0.209512 0.33955 -0.209522 0.0 +1881 3.15 3.15 63.75 -0.251984 -0.259721 0.252092 0.053384 0.25962 -0.0533321 0.0 +1882 3.15 3.15 71.25 -0.171035 -0.17401 0.170979 -0.00382131 0.173971 0.003789 0.0 +1883 3.15 3.15 78.75 -0.103081 -0.108356 0.103106 -0.0377398 0.108153 0.0377189 0.0 +1884 3.15 3.15 86.25 -0.0427632 -0.046394 0.0427713 -0.0466376 0.0463966 0.046639 0.0 +1885 3.15 3.15 93.75 0.00566927 0.00495154 -0.00569908 -0.0428492 -0.00499621 0.0428512 0.0 +1886 3.15 3.15 101.25 0.0504745 0.0463917 -0.0505543 -0.0360707 -0.0464682 0.0360915 0.0 +1887 3.15 3.15 108.75 0.0794281 0.0686813 -0.0795551 -0.0228925 -0.0688457 0.0229235 0.0 +1888 3.15 3.15 116.25 0.0742594 0.061464 -0.0741882 -0.00450275 -0.0615471 0.00449575 0.0 +1889 3.15 3.15 123.75 0.0412054 0.0335455 -0.0410459 0.0122873 -0.0334909 -0.0122658 0.0 +1890 3.15 3.15 131.25 0.00256192 0.00204886 -0.00232937 0.0225283 -0.00204045 -0.0224878 0.0 +1891 3.15 3.15 138.75 -0.0317873 -0.0281822 0.0319935 0.0275685 0.0282669 -0.0275469 0.0 +1892 3.15 3.15 146.25 -0.0711984 -0.0672197 0.0711102 0.0343857 0.0670901 -0.0343675 0.0 +1893 3.15 3.15 153.75 -0.126399 -0.123952 0.126399 0.0498039 0.123889 -0.049802 0.0 +1894 3.15 3.15 161.25 -0.195704 -0.194707 0.195608 0.074158 0.194762 -0.0742025 0.0 +1895 3.15 3.15 168.75 -0.261579 -0.261942 0.261393 0.100026 0.261901 -0.100036 0.0 +1896 3.15 3.15 176.25 -0.301524 -0.302836 0.301604 0.116713 0.302746 -0.116682 0.0 +1897 3.15 3.25 3.75 -650.193 134.226 650.193 17650.1 -134.226 -17650.1 0.0 +1898 3.15 3.25 11.25 -365.979 7.48146 365.979 4109.37 -7.48145 -4109.37 0.0 +1899 3.15 3.25 18.75 -155.208 -30.119 155.208 1115.3 30.119 -1115.3 0.0 +1900 3.15 3.25 26.25 -46.6783 -20.0797 46.6784 237.228 20.0796 -237.228 0.0 +1901 3.15 3.25 33.75 -8.72374 -5.70064 8.7238 31.186 5.70056 -31.186 0.0 +1902 3.15 3.25 41.25 -0.780005 -0.490403 0.779991 1.61053 0.490338 -1.61049 0.0 +1903 3.15 3.25 48.75 -0.160056 -0.188506 0.160035 0.172817 0.188447 -0.172832 0.0 +1904 3.15 3.25 56.25 -0.197253 -0.356173 0.197337 0.156424 0.35612 -0.156432 0.0 +1905 3.15 3.25 63.75 -0.16741 -0.265816 0.167365 0.0571964 0.265815 -0.0571946 0.0 +1906 3.15 3.25 71.25 -0.130237 -0.184874 0.130267 0.00234427 0.184786 -0.0023759 0.0 +1907 3.15 3.25 78.75 -0.0843061 -0.129234 0.0843542 -0.022381 0.129426 0.0223457 0.0 +1908 3.15 3.25 86.25 -0.03979 -0.0657959 0.0398035 -0.0277737 0.0658759 0.0277741 0.0 +1909 3.15 3.25 93.75 -0.00238909 -0.00774928 0.00240125 -0.0282358 0.00785304 0.028235 0.0 +1910 3.15 3.25 101.25 0.0303823 0.0357636 -0.0303854 -0.0222829 -0.0356794 0.0222854 0.0 +1911 3.15 3.25 108.75 0.0506977 0.0585556 -0.0506894 -0.0102554 -0.0584086 0.0102105 0.0 +1912 3.15 3.25 116.25 0.0502104 0.0558613 -0.050186 0.00160465 -0.0559321 -0.00157822 0.0 +1913 3.15 3.25 123.75 0.0345455 0.035523 -0.0344902 0.0104005 -0.0355763 -0.0103987 0.0 +1914 3.15 3.25 131.25 0.0151486 0.0110531 -0.015251 0.0158941 -0.0112994 -0.0157901 0.0 +1915 3.15 3.25 138.75 -0.0050971 -0.013565 0.00511178 0.019016 0.013684 -0.0190174 0.0 +1916 3.15 3.25 146.25 -0.0345021 -0.0459216 0.0345176 0.0233695 0.0459787 -0.0233686 0.0 +1917 3.15 3.25 153.75 -0.0793413 -0.0928252 0.079314 0.0332493 0.092565 -0.033146 0.0 +1918 3.15 3.25 161.25 -0.134603 -0.150218 0.13452 0.0491025 0.150129 -0.0490542 0.0 +1919 3.15 3.25 168.75 -0.18553 -0.204163 0.185623 0.0660649 0.204474 -0.0662343 0.0 +1920 3.15 3.25 176.25 -0.216402 -0.237045 0.216252 0.0770174 0.237253 -0.0771667 0.0 +1921 3.15 3.35 3.75 -275.127 338.879 275.127 11754.8 -338.879 -11754.8 0.0 +1922 3.15 3.35 11.25 -149.928 134.982 149.928 3283.86 -134.982 -3283.86 0.0 +1923 3.15 3.35 18.75 -59.9126 24.6097 59.9126 901.613 -24.6098 -901.613 0.0 +1924 3.15 3.35 26.25 -17.3899 -3.93464 17.3899 190.736 3.93463 -190.736 0.0 +1925 3.15 3.35 33.75 -3.54567 -2.80737 3.54565 25.2257 2.80735 -25.2256 0.0 +1926 3.15 3.35 41.25 -0.5028 -0.297045 0.502764 1.39094 0.297079 -1.39098 0.0 +1927 3.15 3.35 48.75 -0.0786613 -0.21351 0.0785848 0.0781363 0.213592 -0.0781848 0.0 +1928 3.15 3.35 56.25 -0.0749822 -0.340141 0.0749439 0.0885512 0.340151 -0.0884967 0.0 +1929 3.15 3.35 63.75 -0.0903085 -0.233796 0.0902789 0.0251462 0.233735 -0.0251422 0.0 +1930 3.15 3.35 71.25 -0.0742191 -0.168217 0.0742917 -0.0123034 0.168118 0.0122774 0.0 +1931 3.15 3.35 78.75 -0.0442502 -0.131009 0.0441129 -0.0159319 0.131038 0.0159283 0.0 +1932 3.15 3.35 86.25 -0.0140131 -0.074057 0.0140325 -0.0175558 0.0741452 0.0175633 0.0 +1933 3.15 3.35 93.75 0.0107044 -0.016984 -0.0107096 -0.0224514 0.0169392 0.0224516 0.0 +1934 3.15 3.35 101.25 0.0273468 0.0283944 -0.0273571 -0.0182899 -0.0285471 0.0182767 0.0 +1935 3.15 3.35 108.75 0.0341621 0.05763 -0.0342268 -0.00978414 -0.0577058 0.00979257 0.0 +1936 3.15 3.35 116.25 0.0303908 0.0623219 -0.030319 -0.00386081 -0.0623156 0.00386282 0.0 +1937 3.15 3.35 123.75 0.0193498 0.0473473 -0.0192958 0.00117491 -0.0471971 -0.0012989 0.0 +1938 3.15 3.35 131.25 0.00780853 0.0276758 -0.00776157 0.00608841 -0.0275645 -0.00615459 0.0 +1939 3.15 3.35 138.75 -0.00281951 0.00980171 0.0028173 0.00899561 -0.0103754 -0.00875617 0.0 +1940 3.15 3.35 146.25 -0.0177849 -0.0122083 0.0178591 0.0111587 0.0120863 -0.0110729 0.0 +1941 3.15 3.35 153.75 -0.0428755 -0.0468128 0.0427986 0.0164875 0.0467219 -0.0164577 0.0 +1942 3.15 3.35 161.25 -0.0757418 -0.0922436 0.0757394 0.0263114 0.0922185 -0.0263166 0.0 +1943 3.15 3.35 168.75 -0.107642 -0.136426 0.107584 0.0374315 0.136228 -0.0373364 0.0 +1944 3.15 3.35 176.25 -0.127132 -0.16362 0.127062 0.0447389 0.163558 -0.0447096 0.0 +1945 3.15 3.45 3.75 46.6657 326.302 -46.6657 5480.32 -326.302 -5480.32 0.0 +1946 3.15 3.45 11.25 39.3764 154.267 -39.3764 1815.17 -154.267 -1815.17 0.0 +1947 3.15 3.45 18.75 22.0244 42.3138 -22.0244 505.91 -42.3138 -505.91 0.0 +1948 3.15 3.45 26.25 7.29371 4.3406 -7.29372 105.668 -4.3406 -105.668 0.0 +1949 3.15 3.45 33.75 0.914334 -0.603679 -0.914334 13.7287 0.603677 -13.7287 0.0 +1950 3.15 3.45 41.25 -0.158065 -0.0326246 0.158056 0.711344 0.0326778 -0.711315 0.0 +1951 3.15 3.45 48.75 -0.0159738 -0.166204 0.0159671 0.0133403 0.16615 -0.0133219 0.0 +1952 3.15 3.45 56.25 -0.00488119 -0.253233 0.00491148 0.0471634 0.253244 -0.0471562 0.0 +1953 3.15 3.45 63.75 -0.0387289 -0.159738 0.0387929 0.00737726 0.159718 -0.00733701 0.0 +1954 3.15 3.45 71.25 -0.0342167 -0.123108 0.0342095 -0.0134089 0.123119 0.0133794 0.0 +1955 3.15 3.45 78.75 -0.0183889 -0.107233 0.0183971 -0.00702141 0.10719 0.00700092 0.0 +1956 3.15 3.45 86.25 -0.00224304 -0.0672358 0.00223149 -0.00740458 0.06732 0.00740179 0.0 +1957 3.15 3.45 93.75 0.00883338 -0.0235886 -0.00886164 -0.0107045 0.0235433 0.0107089 0.0 +1958 3.15 3.45 101.25 0.0123235 0.015828 -0.012348 -0.00762384 -0.0158064 0.00760398 0.0 +1959 3.15 3.45 108.75 0.0118714 0.0452165 -0.0118843 -0.00509858 -0.0451645 0.00505638 0.0 +1960 3.15 3.45 116.25 0.00859034 0.0531575 -0.00865278 -0.00443542 -0.0532255 0.00444204 0.0 +1961 3.15 3.45 123.75 0.00258788 0.0423716 -0.00256692 -0.00117868 -0.0424366 0.00121603 0.0 +1962 3.15 3.45 131.25 -0.00267606 0.0273421 0.00253797 0.00313079 -0.0273467 -0.00313102 0.0 +1963 3.15 3.45 138.75 -0.00458018 0.0145732 0.00460276 0.00490419 -0.0145389 -0.00492224 0.0 +1964 3.15 3.45 146.25 -0.00839922 -0.00315912 0.00836753 0.00593978 0.00307101 -0.00589991 0.0 +1965 3.15 3.45 153.75 -0.0209444 -0.0338477 0.020904 0.0108714 0.0337667 -0.0108179 0.0 +1966 3.15 3.45 161.25 -0.0433497 -0.0756648 0.043318 0.020838 0.0757092 -0.0208768 0.0 +1967 3.15 3.45 168.75 -0.0683875 -0.116448 0.0683041 0.0321496 0.116416 -0.0321632 0.0 +1968 3.15 3.45 176.25 -0.0847651 -0.141502 0.0847114 0.0395279 0.141475 -0.0394984 0.0 +1969 3.15 3.55 3.75 113.453 150.898 -113.453 1527.06 -150.898 -1527.06 0.0 +1970 3.15 3.55 11.25 75.6979 75.7027 -75.6979 574.861 -75.7027 -574.861 0.0 +1971 3.15 3.55 18.75 35.5664 22.022 -35.5664 161.502 -22.022 -161.502 0.0 +1972 3.15 3.55 26.25 10.941 2.87256 -10.941 32.6315 -2.87256 -32.6315 0.0 +1973 3.15 3.55 33.75 1.72278 0.0375193 -1.7228 3.93133 -0.0374953 -3.93134 0.0 +1974 3.15 3.55 41.25 0.0142898 0.108618 -0.0143047 0.136579 -0.108608 -0.136591 0.0 +1975 3.15 3.55 48.75 0.00816166 -0.0380896 -0.00814953 0.010256 0.0380813 -0.0102749 0.0 +1976 3.15 3.55 56.25 0.0124306 -0.0965177 -0.0124185 0.0389722 0.0965193 -0.0389853 0.0 +1977 3.15 3.55 63.75 -0.00596526 -0.0594462 0.00595775 0.0133454 0.0594234 -0.0133421 0.0 +1978 3.15 3.55 71.25 -0.00358192 -0.0502022 0.00356674 -0.001576 0.0502323 0.00155584 0.0 +1979 3.15 3.55 78.75 0.000427233 -0.0447805 -0.000397985 -0.000360659 0.0448087 0.000358663 0.0 +1980 3.15 3.55 86.25 0.00221954 -0.0289613 -0.00224103 0.000309741 0.0290046 -0.000307859 0.0 +1981 3.15 3.55 93.75 0.00167606 -0.0143391 -0.0016639 0.000808733 0.0143451 -0.000807743 0.0 +1982 3.15 3.55 101.25 0.00112826 0.001235 -0.00111313 0.000644257 -0.00118443 -0.000655222 0.0 +1983 3.15 3.55 108.75 0.00330286 0.0161835 -0.00328457 -0.00210868 -0.0161684 0.00210336 0.0 +1984 3.15 3.55 116.25 0.00487387 0.021415 -0.00489745 -0.00297998 -0.0214282 0.00298062 0.0 +1985 3.15 3.55 123.75 0.00293975 0.016899 -0.00293859 0.000267886 -0.0168868 -0.000264266 0.0 +1986 3.15 3.55 131.25 -0.000108452 0.0105143 0.000105308 0.0034128 -0.0105219 -0.00340601 0.0 +1987 3.15 3.55 138.75 -0.0019759 0.00532812 0.00199003 0.00354695 -0.00537804 -0.00353067 0.0 +1988 3.15 3.55 146.25 -0.00603215 -0.00319989 0.00603288 0.00350166 0.0031536 -0.00347955 0.0 +1989 3.15 3.55 153.75 -0.0177873 -0.0194322 0.017795 0.00752565 0.0194683 -0.00752983 0.0 +1990 3.15 3.55 161.25 -0.0380423 -0.0418389 0.038072 0.0161592 0.041823 -0.016153 0.0 +1991 3.15 3.55 168.75 -0.0604183 -0.0634358 0.0604406 0.025925 0.0634577 -0.0259272 0.0 +1992 3.15 3.55 176.25 -0.0751419 -0.0766462 0.0751429 0.0322594 0.0766293 -0.0322626 0.0 +1993 3.15 3.65 3.75 22.6045 15.6092 -22.6045 111.52 -15.6092 -111.52 0.0 +1994 3.15 3.65 11.25 14.9574 7.74254 -14.9574 45.5783 -7.74254 -45.5783 0.0 +1995 3.15 3.65 18.75 6.90511 1.96171 -6.90511 12.5917 -1.96171 -12.5917 0.0 +1996 3.15 3.65 26.25 2.1033 0.0752923 -2.1033 2.33462 -0.0752924 -2.33462 0.0 +1997 3.15 3.65 33.75 0.345582 -0.0501268 -0.345582 0.224112 0.0501278 -0.224114 0.0 +1998 3.15 3.65 41.25 0.0113715 0.0247154 -0.0113732 -0.00142732 -0.0247142 0.00142719 0.0 +1999 3.15 3.65 48.75 6.87534e-06 0.0140289 -8.51151e-06 0.00563543 -0.0140289 -0.00563605 0.0 +2000 3.15 3.65 56.25 0.00107984 0.0029724 -0.00108132 0.0085864 -0.00297002 -0.00858758 0.0 +2001 3.15 3.65 63.75 0.000469516 0.00270845 -0.000469271 0.00350089 -0.00271011 -0.00350175 0.0 +2002 3.15 3.65 71.25 0.00166924 0.00153728 -0.00167029 0.000471675 -0.00153501 -0.000472585 0.0 +2003 3.15 3.65 78.75 0.00174748 0.00147027 -0.00174735 0.000292892 -0.00147097 -0.000293091 0.0 +2004 3.15 3.65 86.25 0.000889203 0.00101364 -0.000888457 0.000849106 -0.00101254 -0.000849064 0.0 +2005 3.15 3.65 93.75 2.8391e-05 -0.000779719 -2.40476e-05 0.00107302 0.000781464 -0.0010731 0.0 +2006 3.15 3.65 101.25 0.000123662 -0.00119237 -0.000121972 0.000258462 0.00119287 -0.000258603 0.0 +2007 3.15 3.65 108.75 0.000918738 -7.37641e-05 -0.000914812 -0.00070731 7.40479e-05 0.000707953 0.0 +2008 3.15 3.65 116.25 0.00087327 0.000204194 -0.000871841 -0.000333298 -0.000200322 0.000333731 0.0 +2009 3.15 3.65 123.75 -0.000487938 -0.000958429 0.000488243 0.000977954 0.000952902 -0.000975387 0.0 +2010 3.15 3.65 131.25 -0.00192454 -0.00214305 0.00192471 0.00156629 0.00213806 -0.00156455 0.0 +2011 3.15 3.65 138.75 -0.00245031 -0.00237129 0.00244858 0.000874281 0.00237286 -0.000874291 0.0 +2012 3.15 3.65 146.25 -0.00267054 -0.00197417 0.00267194 -7.6905e-05 0.00197292 7.72814e-05 0.0 +2013 3.15 3.65 153.75 -0.00396803 -0.00167631 0.00396857 -7.83088e-05 0.00167684 7.95127e-05 0.0 +2014 3.15 3.65 161.25 -0.00685387 -0.0017756 0.00685877 0.001108 0.0017796 -0.00110938 0.0 +2015 3.15 3.65 168.75 -0.0103819 -0.00210183 0.0103815 0.00276801 0.00210519 -0.00277039 0.0 +2016 3.15 3.65 176.25 -0.0127948 -0.0023518 0.0127908 0.00391691 0.00234768 -0.00391514 0.0 +2017 3.25 2.55 3.75 -59.5545 -1160.49 59.5545 1973.77 1160.49 -1973.77 0.0 +2018 3.25 2.55 11.25 56.844 -883.608 -56.844 989.381 883.608 -989.381 0.0 +2019 3.25 2.55 18.75 150.984 -517.626 -150.984 245.884 517.626 -245.884 0.0 +2020 3.25 2.55 26.25 157.168 -217.116 -157.168 -29.2846 217.116 29.2846 0.0 +2021 3.25 2.55 33.75 104.452 -35.7233 -104.452 -62.8432 35.7233 62.8432 0.0 +2022 3.25 2.55 41.25 45.7976 43.3017 -45.7976 -37.3073 -43.3018 37.3072 0.0 +2023 3.25 2.55 48.75 9.60869 61.5692 -9.60866 -20.3111 -61.5692 20.3112 0.0 +2024 3.25 2.55 56.25 -4.20215 55.2685 4.20214 -17.2817 -55.2685 17.2817 0.0 +2025 3.25 2.55 63.75 -6.66487 44.7328 6.66491 -19.5438 -44.7328 19.5438 0.0 +2026 3.25 2.55 71.25 -6.50581 36.3932 6.50582 -21.044 -36.3932 21.044 0.0 +2027 3.25 2.55 78.75 -7.21586 29.4638 7.21588 -19.4803 -29.4638 19.4803 0.0 +2028 3.25 2.55 86.25 -8.72782 22.0388 8.72785 -15.2322 -22.0388 15.2322 0.0 +2029 3.25 2.55 93.75 -9.40848 13.7576 9.40845 -10.2135 -13.7576 10.2135 0.0 +2030 3.25 2.55 101.25 -7.64177 5.41324 7.64175 -6.28364 -5.41318 6.28364 0.0 +2031 3.25 2.55 108.75 -2.88942 -2.25162 2.88943 -4.15915 2.25161 4.15916 0.0 +2032 3.25 2.55 116.25 4.12591 -9.02031 -4.1259 -3.45148 9.02031 3.45149 0.0 +2033 3.25 2.55 123.75 11.9997 -14.9628 -11.9997 -3.35136 14.9629 3.35133 0.0 +2034 3.25 2.55 131.25 19.3907 -20.1146 -19.3907 -3.21822 20.1146 3.21823 0.0 +2035 3.25 2.55 138.75 25.4561 -24.4049 -25.456 -2.78061 24.4049 2.78061 0.0 +2036 3.25 2.55 146.25 29.9071 -27.7562 -29.9071 -2.05757 27.7562 2.05754 0.0 +2037 3.25 2.55 153.75 32.8539 -30.1787 -32.854 -1.20409 30.1786 1.2041 0.0 +2038 3.25 2.55 161.25 34.6093 -31.7823 -34.6093 -0.396587 31.7823 0.396598 0.0 +2039 3.25 2.55 168.75 35.53 -32.7268 -35.5301 0.221162 32.7267 -0.221124 0.0 +2040 3.25 2.55 176.25 35.9092 -33.157 -35.9092 0.553508 33.1571 -0.553511 0.0 +2041 3.25 2.65 3.75 -364.619 -1177.24 364.619 3261.15 1177.24 -3261.15 0.0 +2042 3.25 2.65 11.25 -170.944 -882.259 170.944 1601.98 882.259 -1601.98 0.0 +2043 3.25 2.65 18.75 7.97343 -512.971 -7.97344 473.428 512.971 -473.428 0.0 +2044 3.25 2.65 26.25 76.8197 -225.459 -76.8197 55.4429 225.459 -55.4429 0.0 +2045 3.25 2.65 33.75 63.1706 -60.3759 -63.1705 -25.1786 60.3759 25.1786 0.0 +2046 3.25 2.65 41.25 26.9972 9.4952 -26.9972 -17.0011 -9.4952 17.0011 0.0 +2047 3.25 2.65 48.75 3.21426 27.5458 -3.21427 -7.89242 -27.5458 7.89243 0.0 +2048 3.25 2.65 56.25 -4.19276 25.9514 4.19277 -7.71957 -25.9514 7.71956 0.0 +2049 3.25 2.65 63.75 -3.58514 20.9867 3.58512 -10.032 -20.9868 10.032 0.0 +2050 3.25 2.65 71.25 -1.8218 17.5583 1.82182 -11.0933 -17.5583 11.0933 0.0 +2051 3.25 2.65 78.75 -1.42207 15.0684 1.42209 -10.072 -15.0684 10.0719 0.0 +2052 3.25 2.65 86.25 -2.18006 12.0219 2.18006 -7.5761 -12.0219 7.57611 0.0 +2053 3.25 2.65 93.75 -2.7903 8.07822 2.79028 -4.90189 -8.07821 4.9019 0.0 +2054 3.25 2.65 101.25 -2.02796 3.78203 2.02793 -3.09994 -3.78201 3.09993 0.0 +2055 3.25 2.65 108.75 0.483472 -0.355942 -0.483506 -2.39117 0.355959 2.39116 0.0 +2056 3.25 2.65 116.25 4.21545 -4.19385 -4.21545 -2.34867 4.19387 2.34866 0.0 +2057 3.25 2.65 123.75 8.24608 -7.74498 -8.24604 -2.42106 7.74505 2.42104 0.0 +2058 3.25 2.65 131.25 11.8028 -10.9489 -11.8028 -2.27777 10.9489 2.27773 0.0 +2059 3.25 2.65 138.75 14.4961 -13.663 -14.4961 -1.85408 13.663 1.85407 0.0 +2060 3.25 2.65 146.25 16.276 -15.7727 -16.2759 -1.2414 15.7727 1.24142 0.0 +2061 3.25 2.65 153.75 17.2907 -17.2659 -17.2907 -0.574592 17.266 0.574543 0.0 +2062 3.25 2.65 161.25 17.7665 -18.2245 -17.7665 0.0269533 18.2244 -0.0269058 0.0 +2063 3.25 2.65 168.75 17.9306 -18.771 -17.9305 0.475387 18.7711 -0.475413 0.0 +2064 3.25 2.65 176.25 17.963 -19.0139 -17.9629 0.71373 19.0138 -0.713725 0.0 +2065 3.25 2.75 3.75 -650.81 -1112.84 650.81 4991.17 1112.84 -4991.17 0.0 +2066 3.25 2.75 11.25 -376.912 -814.423 376.912 2284.82 814.423 -2284.82 0.0 +2067 3.25 2.75 18.75 -117.877 -461.215 117.877 695.625 461.215 -695.625 0.0 +2068 3.25 2.75 26.25 8.67283 -200.478 -8.67283 127.828 200.478 -127.828 0.0 +2069 3.25 2.75 33.75 30.7578 -59.6663 -30.7577 1.67013 59.6663 -1.67014 0.0 +2070 3.25 2.75 41.25 14.4779 -3.75451 -14.4779 -5.11202 3.75449 5.112 0.0 +2071 3.25 2.75 48.75 0.564337 10.5362 -0.564367 -1.71911 -10.5363 1.71911 0.0 +2072 3.25 2.75 56.25 -2.87617 10.6345 2.87615 -3.06902 -10.6345 3.06903 0.0 +2073 3.25 2.75 63.75 -1.22692 8.54812 1.22688 -4.99683 -8.54813 4.99685 0.0 +2074 3.25 2.75 71.25 0.676625 7.54109 -0.676628 -5.57438 -7.5411 5.57438 0.0 +2075 3.25 2.75 78.75 1.26747 7.12286 -1.26752 -4.88162 -7.12286 4.88162 0.0 +2076 3.25 2.75 86.25 0.821253 6.2155 -0.821271 -3.51573 -6.2155 3.51573 0.0 +2077 3.25 2.75 93.75 0.269172 4.5723 -0.269183 -2.24524 -4.57233 2.24524 0.0 +2078 3.25 2.75 101.25 0.429798 2.5731 -0.429775 -1.56964 -2.57305 1.56964 0.0 +2079 3.25 2.75 108.75 1.51112 0.548777 -1.51111 -1.46189 -0.548758 1.46189 0.0 +2080 3.25 2.75 116.25 3.14107 -1.42811 -3.14111 -1.57905 1.428 1.57906 0.0 +2081 3.25 2.75 123.75 4.77902 -3.35524 -4.77897 -1.60881 3.35532 1.60877 0.0 +2082 3.25 2.75 131.25 6.0623 -5.14646 -6.06231 -1.42923 5.14643 1.42921 0.0 +2083 3.25 2.75 138.75 6.88223 -6.66178 -6.88228 -1.07207 6.66181 1.07204 0.0 +2084 3.25 2.75 146.25 7.29129 -7.80724 -7.29129 -0.62631 7.80721 0.626318 0.0 +2085 3.25 2.75 153.75 7.40168 -8.58128 -7.40163 -0.175775 8.58129 0.175784 0.0 +2086 3.25 2.75 161.25 7.33627 -9.05184 -7.33623 0.217137 9.05186 -0.217144 0.0 +2087 3.25 2.75 168.75 7.21123 -9.30667 -7.21121 0.506879 9.3067 -0.50691 0.0 +2088 3.25 2.75 176.25 7.12142 -9.41579 -7.12147 0.660755 9.41579 -0.660753 0.0 +2089 3.25 2.85 3.75 -874.718 -974.414 874.718 7259.84 974.414 -7259.84 0.0 +2090 3.25 2.85 11.25 -529.957 -697.024 529.957 2965.19 697.024 -2965.19 0.0 +2091 3.25 2.85 18.75 -210.49 -383.275 210.49 886.088 383.275 -886.088 0.0 +2092 3.25 2.85 26.25 -41.3105 -160.664 41.3105 182.067 160.664 -182.067 0.0 +2093 3.25 2.85 33.75 7.80209 -47.4025 -7.8021 18.2185 47.4025 -18.2185 0.0 +2094 3.25 2.85 41.25 6.66425 -6.22131 -6.66427 0.514926 6.22131 -0.514937 0.0 +2095 3.25 2.85 48.75 -0.257506 3.34457 0.257528 0.598091 -3.34461 -0.598088 0.0 +2096 3.25 2.85 56.25 -1.60108 3.68626 1.60109 -1.12836 -3.68629 1.12836 0.0 +2097 3.25 2.85 63.75 -0.0562389 2.92276 0.0562531 -2.4777 -2.92278 2.47769 0.0 +2098 3.25 2.85 71.25 1.34259 2.85177 -1.34259 -2.68723 -2.85177 2.68723 0.0 +2099 3.25 2.85 78.75 1.78217 3.08196 -1.7822 -2.22735 -3.08197 2.22735 0.0 +2100 3.25 2.85 86.25 1.51729 2.94458 -1.51724 -1.5416 -2.94457 1.5416 0.0 +2101 3.25 2.85 93.75 1.11672 2.32415 -1.11672 -1.01515 -2.32408 1.01514 0.0 +2102 3.25 2.85 101.25 1.04827 1.48668 -1.04823 -0.8323 -1.48656 0.832297 0.0 +2103 3.25 2.85 108.75 1.38957 0.621054 -1.38956 -0.889911 -0.621024 0.889912 0.0 +2104 3.25 2.85 116.25 1.89694 -0.261405 -1.89687 -0.969374 0.26136 0.969375 0.0 +2105 3.25 2.85 123.75 2.30175 -1.1663 -2.3017 -0.931747 1.16616 0.931784 0.0 +2106 3.25 2.85 131.25 2.49539 -2.02222 -2.49531 -0.76339 2.02229 0.763392 0.0 +2107 3.25 2.85 138.75 2.50552 -2.72913 -2.50545 -0.516076 2.72907 0.516141 0.0 +2108 3.25 2.85 146.25 2.39795 -3.23443 -2.39795 -0.243855 3.23438 0.243866 0.0 +2109 3.25 2.85 153.75 2.22514 -3.55264 -2.22503 0.0183988 3.55282 -0.0184731 0.0 +2110 3.25 2.85 161.25 2.02888 -3.73535 -2.02881 0.247142 3.73533 -0.247116 0.0 +2111 3.25 2.85 168.75 1.85569 -3.83283 -1.85573 0.419517 3.83292 -0.419559 0.0 +2112 3.25 2.85 176.25 1.75351 -3.87538 -1.75346 0.513033 3.87536 -0.513003 0.0 +2113 3.25 2.95 3.75 -994.675 -761.925 994.675 10167.8 761.925 -10167.8 0.0 +2114 3.25 2.95 11.25 -604.142 -541.804 604.142 3540.59 541.804 -3540.59 0.0 +2115 3.25 2.95 18.75 -258.167 -293.834 258.167 1019.93 293.834 -1019.93 0.0 +2116 3.25 2.95 26.25 -69.6148 -118.714 69.6148 215.024 118.714 -215.024 0.0 +2117 3.25 2.95 33.75 -5.90221 -32.9966 5.90223 26.311 32.9965 -26.3109 0.0 +2118 3.25 2.95 41.25 2.25602 -4.6363 -2.256 2.23549 4.63633 -2.23548 0.0 +2119 3.25 2.95 48.75 -0.381153 0.893766 0.381197 0.984491 -0.893795 -0.984484 0.0 +2120 3.25 2.95 56.25 -0.837566 1.03175 0.837613 -0.404101 -1.03172 0.404103 0.0 +2121 3.25 2.95 63.75 0.175542 0.816121 -0.175492 -1.20167 -0.816067 1.20172 0.0 +2122 3.25 2.95 71.25 0.973076 0.964456 -0.973105 -1.22149 -0.964472 1.22153 0.0 +2123 3.25 2.95 78.75 1.22755 1.20413 -1.22756 -0.952588 -1.20413 0.952604 0.0 +2124 3.25 2.95 86.25 1.11328 1.21193 -1.11325 -0.647389 -1.21189 0.647396 0.0 +2125 3.25 2.95 93.75 0.908821 0.978321 -0.908822 -0.460875 -0.978329 0.460874 0.0 +2126 3.25 2.95 101.25 0.833653 0.675263 -0.833527 -0.437086 -0.675046 0.437092 0.0 +2127 3.25 2.95 108.75 0.892478 0.384331 -0.892482 -0.487806 -0.384525 0.487835 0.0 +2128 3.25 2.95 116.25 0.941912 0.0767676 -0.941915 -0.503087 -0.0768796 0.50313 0.0 +2129 3.25 2.95 123.75 0.880255 -0.264114 -0.880225 -0.441399 0.264088 0.441378 0.0 +2130 3.25 2.95 131.25 0.721429 -0.593478 -0.721462 -0.324258 0.59346 0.324254 0.0 +2131 3.25 2.95 138.75 0.529658 -0.854889 -0.529654 -0.187313 0.854907 0.187341 0.0 +2132 3.25 2.95 146.25 0.343385 -1.03082 -0.343423 -0.0495403 1.03079 0.0495952 0.0 +2133 3.25 2.95 153.75 0.166185 -1.14208 -0.166078 0.084722 1.14224 -0.0847717 0.0 +2134 3.25 2.95 161.25 -0.0023326 -1.21841 0.00240849 0.210111 1.21855 -0.210151 0.0 +2135 3.25 2.95 168.75 -0.143824 -1.27394 0.143828 0.311754 1.27397 -0.311766 0.0 +2136 3.25 2.95 176.25 -0.226551 -1.30554 0.226594 0.369648 1.30568 -0.369696 0.0 +2137 3.25 3.05 3.75 -978.964 -476.941 978.964 13691.9 476.941 -13691.9 0.0 +2138 3.25 3.05 11.25 -585.6 -358.907 585.6 3897.55 358.907 -3897.55 0.0 +2139 3.25 3.05 18.75 -256.707 -201.647 256.707 1079.65 201.647 -1079.65 0.0 +2140 3.25 3.05 26.25 -76.2438 -81.0977 76.2438 226.645 81.0977 -226.645 0.0 +2141 3.25 3.05 33.75 -11.5833 -21.1654 11.5832 28.5061 21.1655 -28.5061 0.0 +2142 3.25 3.05 41.25 0.173619 -2.61963 -0.173607 2.10869 2.61962 -2.10865 0.0 +2143 3.25 3.05 48.75 -0.315471 0.211809 0.315507 0.701655 -0.211816 -0.701697 0.0 +2144 3.25 3.05 56.25 -0.505868 0.156217 0.505813 -0.107758 -0.156216 0.107744 0.0 +2145 3.25 3.05 63.75 -0.00347947 0.148027 0.00347438 -0.508426 -0.147997 0.508423 0.0 +2146 3.25 3.05 71.25 0.35623 0.275174 -0.356316 -0.485913 -0.275183 0.485916 0.0 +2147 3.25 3.05 78.75 0.491691 0.385673 -0.491641 -0.368162 -0.385769 0.368161 0.0 +2148 3.25 3.05 86.25 0.488401 0.383863 -0.48842 -0.257055 -0.383836 0.257051 0.0 +2149 3.25 3.05 93.75 0.440596 0.300647 -0.440558 -0.200164 -0.300597 0.200155 0.0 +2150 3.25 3.05 101.25 0.428503 0.226143 -0.428439 -0.201568 -0.226229 0.201576 0.0 +2151 3.25 3.05 108.75 0.433838 0.178273 -0.433894 -0.215213 -0.17832 0.215235 0.0 +2152 3.25 3.05 116.25 0.381927 0.115261 -0.381976 -0.200265 -0.115315 0.200286 0.0 +2153 3.25 3.05 123.75 0.250762 0.0199942 -0.250749 -0.152978 -0.0201082 0.153022 0.0 +2154 3.25 3.05 131.25 0.087112 -0.0827914 -0.0871943 -0.0925379 0.0827206 0.0925707 0.0 +2155 3.25 3.05 138.75 -0.059018 -0.166424 0.059112 -0.0336172 0.166526 0.0335871 0.0 +2156 3.25 3.05 146.25 -0.18052 -0.231382 0.180489 0.0245779 0.231091 -0.0244228 0.0 +2157 3.25 3.05 153.75 -0.295942 -0.294287 0.2959 0.0891166 0.294365 -0.089183 0.0 +2158 3.25 3.05 161.25 -0.414913 -0.365011 0.414927 0.159436 0.365193 -0.159527 0.0 +2159 3.25 3.05 168.75 -0.521941 -0.433475 0.521891 0.222797 0.433412 -0.22276 0.0 +2160 3.25 3.05 176.25 -0.586773 -0.476695 0.58675 0.260922 0.476694 -0.260927 0.0 +2161 3.25 3.15 3.75 -814.083 -137.448 814.083 17033 137.448 -17033 0.0 +2162 3.25 3.15 11.25 -477.018 -161.776 477.018 3948.26 161.776 -3948.26 0.0 +2163 3.25 3.15 18.75 -210.543 -111.957 210.543 1059.41 111.957 -1059.41 0.0 +2164 3.25 3.15 26.25 -64.7579 -49.5587 64.7579 219.45 49.5587 -219.45 0.0 +2165 3.25 3.15 33.75 -11.3607 -12.9491 11.3607 27.2729 12.9491 -27.2729 0.0 +2166 3.25 3.15 41.25 -0.501683 -1.37447 0.501697 1.5392 1.37448 -1.53919 0.0 +2167 3.25 3.15 48.75 -0.221118 -0.00415248 0.221156 0.373864 0.00412424 -0.373901 0.0 +2168 3.25 3.15 56.25 -0.358361 -0.136291 0.358397 0.0446509 0.136267 -0.0446373 0.0 +2169 3.25 3.15 63.75 -0.169006 -0.0774782 0.16899 -0.134807 0.0776033 0.134847 0.0 +2170 3.25 3.15 71.25 -0.0396525 0.000838949 0.0396204 -0.138164 -0.000965599 0.138113 0.0 +2171 3.25 3.15 78.75 0.0344374 0.0425985 -0.0344408 -0.11517 -0.0427499 0.115165 0.0 +2172 3.25 3.15 86.25 0.081184 0.0529524 -0.0811964 -0.089771 -0.0528817 0.0897804 0.0 +2173 3.25 3.15 93.75 0.109097 0.0469134 -0.109138 -0.0742976 -0.0469756 0.0743061 0.0 +2174 3.25 3.15 101.25 0.140882 0.0567832 -0.140845 -0.0701795 -0.056761 0.0701752 0.0 +2175 3.25 3.15 108.75 0.161799 0.0792193 -0.161837 -0.0654321 -0.0792445 0.0654376 0.0 +2176 3.25 3.15 116.25 0.136212 0.0826416 -0.136185 -0.0509834 -0.082549 0.0509852 0.0 +2177 3.25 3.15 123.75 0.0646484 0.0562433 -0.0646738 -0.0282995 -0.0561666 0.0282081 0.0 +2178 3.25 3.15 131.25 -0.0160401 0.016597 0.0162145 -0.00533023 -0.0166918 0.00541668 0.0 +2179 3.25 3.15 138.75 -0.0817391 -0.0230835 0.0817603 0.0141581 0.0232302 -0.0142084 0.0 +2180 3.25 3.15 146.25 -0.139744 -0.0669364 0.139812 0.0354497 0.0671282 -0.0355434 0.0 +2181 3.25 3.15 153.75 -0.209767 -0.126707 0.209696 0.0659929 0.126592 -0.0659876 0.0 +2182 3.25 3.15 161.25 -0.294722 -0.202261 0.294788 0.105695 0.202334 -0.105724 0.0 +2183 3.25 3.15 168.75 -0.376427 -0.2763 0.376427 0.144617 0.276396 -0.144692 0.0 +2184 3.25 3.15 176.25 -0.426876 -0.322774 0.42683 0.16886 0.322923 -0.168938 0.0 +2185 3.25 3.25 3.75 -516.093 207.353 516.093 17519 -207.353 -17519 0.0 +2186 3.25 3.25 11.25 -297.818 30.2999 297.818 3670.93 -30.2999 -3670.93 0.0 +2187 3.25 3.25 18.75 -131.533 -29.3583 131.533 966.016 29.3582 -966.016 0.0 +2188 3.25 3.25 26.25 -41.2561 -23.5547 41.2561 197.399 23.5547 -197.399 0.0 +2189 3.25 3.25 33.75 -7.77181 -7.42064 7.77175 24.324 7.42059 -24.3239 0.0 +2190 3.25 3.25 41.25 -0.520054 -0.786867 0.520059 1.16473 0.786915 -1.16475 0.0 +2191 3.25 3.25 48.75 -0.135385 -0.107324 0.135384 0.176595 0.107322 -0.176651 0.0 +2192 3.25 3.25 56.25 -0.236403 -0.233969 0.236341 0.100092 0.234021 -0.099998 0.0 +2193 3.25 3.25 63.75 -0.177344 -0.160255 0.177338 0.016127 0.160281 -0.0161542 0.0 +2194 3.25 3.25 71.25 -0.134993 -0.110418 0.134999 -0.0109067 0.110353 0.010913 0.0 +2195 3.25 3.25 78.75 -0.0950825 -0.0779897 0.0951253 -0.021928 0.077927 0.0219105 0.0 +2196 3.25 3.25 86.25 -0.0482799 -0.0371325 0.0482478 -0.0253972 0.0372349 0.0254039 0.0 +2197 3.25 3.25 93.75 -0.00935062 -0.00567433 0.00930825 -0.0233964 0.0056727 0.0233906 0.0 +2198 3.25 3.25 101.25 0.0268556 0.0229776 -0.0268747 -0.016636 -0.0229697 0.0166413 0.0 +2199 3.25 3.25 108.75 0.0559475 0.0486988 -0.0559577 -0.010512 -0.0487913 0.0105343 0.0 +2200 3.25 3.25 116.25 0.0599605 0.0541495 -0.0598537 -0.00538128 -0.0541128 0.00538138 0.0 +2201 3.25 3.25 123.75 0.0386584 0.0352012 -0.038683 0.00205185 -0.0351223 -0.00210039 0.0 +2202 3.25 3.25 131.25 0.0113902 0.00756233 -0.0112221 0.0099077 -0.00759024 -0.00983246 0.0 +2203 3.25 3.25 138.75 -0.0116709 -0.0175027 0.0116404 0.0150778 0.0175656 -0.0151232 0.0 +2204 3.25 3.25 146.25 -0.0379372 -0.0440118 0.0378931 0.0202482 0.0440189 -0.0202764 0.0 +2205 3.25 3.25 153.75 -0.0789016 -0.0826345 0.0789715 0.0309487 0.0826604 -0.0309747 0.0 +2206 3.25 3.25 161.25 -0.13326 -0.134571 0.133258 0.0482225 0.134355 -0.0481305 0.0 +2207 3.25 3.25 168.75 -0.185796 -0.186751 0.185766 0.0666972 0.186837 -0.0667545 0.0 +2208 3.25 3.25 176.25 -0.217924 -0.219808 0.217907 0.078575 0.219826 -0.0785566 0.0 +2209 3.25 3.35 3.75 -136.489 468.84 136.489 13261.2 -468.84 -13261.2 0.0 +2210 3.25 3.35 11.25 -76.3677 186.541 76.3677 3006.19 -186.541 -3006.19 0.0 +2211 3.25 3.35 18.75 -34.4387 38.7843 34.4388 785.234 -38.7843 -785.234 0.0 +2212 3.25 3.35 26.25 -12.2064 -2.42532 12.2063 158.413 2.42535 -158.413 0.0 +2213 3.25 3.35 33.75 -3.01753 -3.19124 3.01752 19.5862 3.19127 -19.5862 0.0 +2214 3.25 3.35 41.25 -0.376538 -0.403329 0.376502 0.965951 0.403384 -0.965979 0.0 +2215 3.25 3.35 48.75 -0.0663706 -0.151905 0.066354 0.0762885 0.151928 -0.0763483 0.0 +2216 3.25 3.35 56.25 -0.115811 -0.241426 0.115854 0.0757353 0.241441 -0.0756865 0.0 +2217 3.25 3.35 63.75 -0.10133 -0.1561 0.101333 0.0257088 0.156123 -0.0256754 0.0 +2218 3.25 3.35 71.25 -0.0830317 -0.123866 0.083011 0.00222966 0.123776 -0.00226914 0.0 +2219 3.25 3.35 78.75 -0.0648663 -0.0963338 0.0649114 -0.00193966 0.0962687 0.00191896 0.0 +2220 3.25 3.35 86.25 -0.0348832 -0.0452658 0.0348888 -0.00953403 0.0452114 0.00953002 0.0 +2221 3.25 3.35 93.75 -0.00930256 -0.00606384 0.00931036 -0.0124204 0.00592252 0.0124271 0.0 +2222 3.25 3.35 101.25 0.0100895 0.0236635 -0.0100704 -0.00601918 -0.0236457 0.00599972 0.0 +2223 3.25 3.35 108.75 0.0265883 0.0477513 -0.0265736 -0.00229502 -0.0475016 0.00223504 0.0 +2224 3.25 3.35 116.25 0.0315534 0.0512958 -0.0315658 -0.00201565 -0.0511774 0.00205073 0.0 +2225 3.25 3.35 123.75 0.0223392 0.0342892 -0.0222605 0.00148067 -0.0341723 -0.00152918 0.0 +2226 3.25 3.35 131.25 0.00941799 0.0153327 -0.00949539 0.00600099 -0.015387 -0.00602979 0.0 +2227 3.25 3.35 138.75 0.00192308 0.00676484 -0.0019709 0.00587968 -0.0067599 -0.00587268 0.0 +2228 3.25 3.35 146.25 -0.00390089 0.00228314 0.00390376 0.00216232 -0.00224221 -0.00219 0.0 +2229 3.25 3.35 153.75 -0.0157319 -0.00974298 0.0157634 0.000201998 0.00958756 -0.00010215 0.0 +2230 3.25 3.35 161.25 -0.0344272 -0.0332355 0.0345224 0.00245974 0.0332678 -0.00241767 0.0 +2231 3.25 3.35 168.75 -0.0539332 -0.0604648 0.0538857 0.00692496 0.0604662 -0.00693555 0.0 +2232 3.25 3.35 176.25 -0.0657833 -0.0784772 0.0659121 0.0101981 0.0784511 -0.0101316 0.0 +2233 3.25 3.45 3.75 160.753 453.103 -160.753 6268.16 -453.103 -6268.16 0.0 +2234 3.25 3.45 11.25 98.9204 211.866 -98.9204 1677.08 -211.866 -1677.08 0.0 +2235 3.25 3.45 18.75 41.6475 62.0615 -41.6475 437.04 -62.0615 -437.04 0.0 +2236 3.25 3.45 26.25 10.2776 8.85177 -10.2776 86.3962 -8.85176 -86.3962 0.0 +2237 3.25 3.45 33.75 0.665198 -0.0281349 -0.665216 10.5941 0.0281541 -10.5942 0.0 +2238 3.25 3.45 41.25 -0.225316 -0.0097665 0.225331 0.540446 0.00977707 -0.540423 0.0 +2239 3.25 3.45 48.75 -0.000555537 -0.138966 0.000568013 0.0245727 0.138941 -0.0245583 0.0 +2240 3.25 3.45 56.25 -0.0247081 -0.191676 0.0246253 0.0387653 0.191736 -0.0387721 0.0 +2241 3.25 3.45 63.75 -0.0406244 -0.104835 0.0405644 0.00218269 0.104904 -0.00218938 0.0 +2242 3.25 3.45 71.25 -0.0316041 -0.0868229 0.0315861 -0.00999292 0.086857 0.00997278 0.0 +2243 3.25 3.45 78.75 -0.0244453 -0.0766617 0.0244139 -0.00348801 0.076724 0.00349178 0.0 +2244 3.25 3.45 86.25 -0.00890648 -0.0447902 0.00892778 -0.00721057 0.0446984 0.00720699 0.0 +2245 3.25 3.45 93.75 0.00249213 -0.015882 -0.00250762 -0.00859341 0.0157787 0.00859132 0.0 +2246 3.25 3.45 101.25 0.00593138 0.0124111 -0.00596771 -0.00363029 -0.0123966 0.00362055 0.0 +2247 3.25 3.45 108.75 0.00849249 0.0372762 -0.00846232 -0.00245363 -0.0373616 0.0024942 0.0 +2248 3.25 3.45 116.25 0.00730472 0.0430354 -0.00734682 -0.00257204 -0.0430353 0.00254668 0.0 +2249 3.25 3.45 123.75 0.000252497 0.0319203 -0.000228003 0.00117018 -0.0317262 -0.00121273 0.0 +2250 3.25 3.45 131.25 -0.00509858 0.0202249 0.00511462 0.00424735 -0.0201591 -0.00429141 0.0 +2251 3.25 3.45 138.75 -0.00189225 0.0157697 0.00192964 0.00188411 -0.0157307 -0.00190094 0.0 +2252 3.25 3.45 146.25 0.00595475 0.0116431 -0.0059073 -0.0030478 -0.0116606 0.00308588 0.0 +2253 3.25 3.45 153.75 0.00984054 -0.000318014 -0.00985575 -0.00518825 0.000191851 0.00524895 0.0 +2254 3.25 3.45 161.25 0.00625952 -0.0201284 -0.00627072 -0.00318494 0.0201728 0.00314475 0.0 +2255 3.25 3.45 168.75 -0.00150526 -0.0406308 0.00144698 0.000485931 0.0405933 -0.00047182 0.0 +2256 3.25 3.45 176.25 -0.00732316 -0.0533522 0.00734119 0.00300328 0.0532394 -0.0029465 0.0 +2257 3.25 3.55 3.75 170.017 215.704 -170.017 1682.14 -215.704 -1682.14 0.0 +2258 3.25 3.55 11.25 104.65 108.392 -104.65 523.152 -108.392 -523.152 0.0 +2259 3.25 3.55 18.75 44.2579 34.3622 -44.2579 134.428 -34.3622 -134.428 0.0 +2260 3.25 3.55 26.25 11.5313 6.21431 -11.5313 25.1215 -6.2143 -25.1215 0.0 +2261 3.25 3.55 33.75 1.18823 0.636226 -1.18825 2.77896 -0.636222 -2.77896 0.0 +2262 3.25 3.55 41.25 -0.090997 0.150717 0.0909756 0.0854078 -0.1507 -0.0854088 0.0 +2263 3.25 3.55 48.75 0.0364606 -0.051279 -0.0364402 0.0168919 0.0512661 -0.0168927 0.0 +2264 3.25 3.55 56.25 0.0111486 -0.090247 -0.0111456 0.0363843 0.090261 -0.0363792 0.0 +2265 3.25 3.55 63.75 -0.0105072 -0.0440459 0.0105073 0.00831444 0.0440284 -0.00831955 0.0 +2266 3.25 3.55 71.25 -0.00433658 -0.0361287 0.00434277 -0.00361399 0.0361351 0.00360689 0.0 +2267 3.25 3.55 78.75 -0.000933427 -0.0350331 0.000939583 -0.00100115 0.0350187 0.00100048 0.0 +2268 3.25 3.55 86.25 0.00219006 -0.0262185 -0.00219325 -0.00134055 0.0262088 0.0013392 0.0 +2269 3.25 3.55 93.75 0.00205156 -0.0171976 -0.00207372 -0.0011449 0.0171792 0.00114581 0.0 +2270 3.25 3.55 101.25 0.000259054 -0.00345069 -0.000235304 -0.00113486 0.00346766 0.00114093 0.0 +2271 3.25 3.55 108.75 0.00134517 0.0104896 -0.0013327 -0.00307345 -0.0104784 0.00307104 0.0 +2272 3.25 3.55 116.25 0.00233262 0.0144818 -0.00234223 -0.00230586 -0.0144733 0.00230359 0.0 +2273 3.25 3.55 123.75 0.00096001 0.00998525 -0.000959656 0.00167455 -0.00992985 -0.00169886 0.0 +2274 3.25 3.55 131.25 0.0010997 0.00500791 -0.00110082 0.00353768 -0.00496742 -0.00356791 0.0 +2275 3.25 3.55 138.75 0.00487751 0.00146684 -0.00487922 0.00142544 -0.00148711 -0.00141137 0.0 +2276 3.25 3.55 146.25 0.00734264 -0.00446313 -0.00734662 -0.000638225 0.00441882 0.000652058 0.0 +2277 3.25 3.55 153.75 0.00197693 -0.014869 -0.00196668 0.0013558 0.0148847 -0.00135051 0.0 +2278 3.25 3.55 161.25 -0.0121606 -0.0275418 0.0121409 0.00720885 0.027516 -0.00721154 0.0 +2279 3.25 3.55 168.75 -0.029033 -0.0382301 0.0290399 0.0137359 0.0382374 -0.01375 0.0 +2280 3.25 3.55 176.25 -0.0403659 -0.0441543 0.0403287 0.0177986 0.0441199 -0.0177946 0.0 +2281 3.25 3.65 3.75 29.8469 23.7536 -29.8469 114.399 -23.7536 -114.399 0.0 +2282 3.25 3.65 11.25 18.5821 12.1922 -18.5821 38.9798 -12.1922 -38.9798 0.0 +2283 3.25 3.65 18.75 7.82427 3.7514 -7.82427 9.32709 -3.7514 -9.32709 0.0 +2284 3.25 3.65 26.25 2.01633 0.610607 -2.01633 1.41075 -0.610606 -1.41076 0.0 +2285 3.25 3.65 33.75 0.207925 0.0661693 -0.207923 0.0650148 -0.0661712 -0.0650166 0.0 +2286 3.25 3.65 41.25 -0.0109411 0.0374143 0.0109448 -0.0172484 -0.0374174 0.0172482 0.0 +2287 3.25 3.65 48.75 0.00854362 0.00771035 -0.00854147 0.00574961 -0.00770984 -0.00574854 0.0 +2288 3.25 3.65 56.25 0.00259756 -0.00264422 -0.00260097 0.00942854 0.00264499 -0.00942948 0.0 +2289 3.25 3.65 63.75 -0.000120554 0.00078573 0.00012058 0.00313857 -0.000784598 -0.00313891 0.0 +2290 3.25 3.65 71.25 0.00248101 0.00185637 -0.00248337 0.000268246 -0.00186001 -0.000268224 0.0 +2291 3.25 3.65 78.75 0.00307847 0.00208771 -0.00307844 0.000606822 -0.00209071 -0.000606483 0.0 +2292 3.25 3.65 86.25 0.00187174 0.00124659 -0.00186937 0.00095551 -0.00124275 -0.000955129 0.0 +2293 3.25 3.65 93.75 6.19913e-05 -0.000371204 -6.04736e-05 0.000563209 0.000365014 -0.000562734 0.0 +2294 3.25 3.65 101.25 -0.000928172 -0.000436879 0.000926995 -0.00063032 0.000434748 0.000630276 0.0 +2295 3.25 3.65 108.75 -0.000830659 0.000473082 0.000832415 -0.00140972 -0.00047285 0.00140969 0.0 +2296 3.25 3.65 116.25 -0.000942827 0.000407146 0.00094397 -0.000633585 -0.000410022 0.000634706 0.0 +2297 3.25 3.65 123.75 -0.00166283 -0.000582597 0.001662 0.000718962 0.000586269 -0.000719648 0.0 +2298 3.25 3.65 131.25 -0.00204479 -0.00128755 0.00204388 0.000938967 0.00128792 -0.000939369 0.0 +2299 3.25 3.65 138.75 -0.00182542 -0.00123409 0.00182692 -0.000123482 0.00123642 0.000123147 0.0 +2300 3.25 3.65 146.25 -0.00225266 -0.000702446 0.00225351 -0.00119521 0.000700296 0.00119733 0.0 +2301 3.25 3.65 153.75 -0.00470753 0.000107114 0.0047067 -0.00120089 -0.000106024 0.00120018 0.0 +2302 3.25 3.65 161.25 -0.00916233 0.00120265 0.0091593 -0.000139049 -0.00120213 0.000137897 0.0 +2303 3.25 3.65 168.75 -0.0140233 0.0024012 0.0140238 0.00124784 -0.00240054 -0.00124848 0.0 +2304 3.25 3.65 176.25 -0.0171689 0.00321938 0.0171732 0.00216427 -0.00322149 -0.00216221 0.0 +2305 3.35 2.55 3.75 -195.276 -1032.14 195.276 1295.85 1032.14 -1295.85 0.0 +2306 3.35 2.55 11.25 -99.2481 -778.391 99.2481 692.781 778.391 -692.781 0.0 +2307 3.35 2.55 18.75 -6.65643 -434.466 6.65643 206.152 434.466 -206.152 0.0 +2308 3.35 2.55 26.25 25.3003 -148.262 -25.3003 18.5522 148.262 -18.5522 0.0 +2309 3.35 2.55 33.75 11.0692 22.9807 -11.0692 -10.9237 -22.9807 10.9237 0.0 +2310 3.35 2.55 41.25 -11.4134 92.7283 11.4135 -6.39065 -92.7283 6.39065 0.0 +2311 3.35 2.55 48.75 -20.2925 102.13 20.2925 -10.1964 -102.13 10.1964 0.0 +2312 3.35 2.55 56.25 -15.5576 88.407 15.5576 -21.035 -88.4069 21.035 0.0 +2313 3.35 2.55 63.75 -6.26392 72.4403 6.2639 -30.0768 -72.4402 30.0768 0.0 +2314 3.35 2.55 71.25 0.338232 60.0655 -0.338249 -32.7453 -60.0655 32.7453 0.0 +2315 3.35 2.55 78.75 1.98951 49.4255 -1.98942 -28.9805 -49.4255 28.9805 0.0 +2316 3.35 2.55 86.25 0.388913 37.8715 -0.388957 -21.6256 -37.8715 21.6256 0.0 +2317 3.35 2.55 93.75 -1.06672 24.8252 1.06667 -14.3056 -24.8253 14.3056 0.0 +2318 3.35 2.55 101.25 0.391277 11.1758 -0.391251 -9.35123 -11.1758 9.35124 0.0 +2319 3.35 2.55 108.75 5.52125 -2.10395 -5.52124 -7.05211 2.10392 7.05212 0.0 +2320 3.35 2.55 116.25 13.2016 -14.4695 -13.2016 -6.36669 14.4695 6.36669 0.0 +2321 3.35 2.55 123.75 21.5401 -25.5906 -21.5401 -6.05939 25.5905 6.0594 0.0 +2322 3.35 2.55 131.25 28.9456 -35.1239 -28.9457 -5.38465 35.1239 5.38469 0.0 +2323 3.35 2.55 138.75 34.5957 -42.757 -34.5957 -4.17193 42.757 4.17195 0.0 +2324 3.35 2.55 146.25 38.3688 -48.3714 -38.3688 -2.60245 48.3714 2.60243 0.0 +2325 3.35 2.55 153.75 40.566 -52.1207 -40.566 -0.967925 52.1205 0.967988 0.0 +2326 3.35 2.55 161.25 41.6506 -54.3691 -41.6506 0.469012 54.3691 -0.468989 0.0 +2327 3.35 2.55 168.75 42.0782 -55.5528 -42.0782 1.52064 55.5528 -1.52067 0.0 +2328 3.35 2.55 176.25 42.1981 -56.041 -42.1981 2.0729 56.0409 -2.0729 0.0 +2329 3.35 2.65 3.75 -419.098 -1076.13 419.098 2153.24 1076.13 -2153.24 0.0 +2330 3.35 2.65 11.25 -264.945 -806.91 264.945 1138.5 806.91 -1138.5 0.0 +2331 3.35 2.65 18.75 -104.618 -457.574 104.618 379.324 457.574 -379.324 0.0 +2332 3.35 2.65 26.25 -21.9706 -179.872 21.9706 82.5542 179.872 -82.5542 0.0 +2333 3.35 2.65 33.75 -6.05842 -20.7051 6.05842 16.3126 20.7051 -16.3126 0.0 +2334 3.35 2.65 41.25 -13.3029 42.8912 13.3029 8.09772 -42.8912 -8.09772 0.0 +2335 3.35 2.65 48.75 -15.6897 54.0943 15.6897 0.0182538 -54.0943 -0.0182479 0.0 +2336 3.35 2.65 56.25 -9.08183 46.7632 9.08183 -10.6957 -46.7632 10.6957 0.0 +2337 3.35 2.65 63.75 0.136459 38.1374 -0.136456 -17.9284 -38.1374 17.9284 0.0 +2338 3.35 2.65 71.25 6.42034 32.5591 -6.42031 -19.5836 -32.5591 19.5836 0.0 +2339 3.35 2.65 78.75 8.18095 28.2195 -8.18103 -16.7768 -28.2195 16.7768 0.0 +2340 3.35 2.65 86.25 6.86543 22.8055 -6.86542 -12.0332 -22.8055 12.0332 0.0 +2341 3.35 2.65 93.75 5.15555 15.8036 -5.15553 -7.84684 -15.8036 7.84684 0.0 +2342 3.35 2.65 101.25 5.16175 7.93989 -5.16173 -5.47191 -7.93991 5.47192 0.0 +2343 3.35 2.65 108.75 7.39932 -0.00491049 -7.39931 -4.70878 0.00495997 4.70878 0.0 +2344 3.35 2.65 116.25 11.02 -7.59843 -11.02 -4.63522 7.59841 4.63521 0.0 +2345 3.35 2.65 123.75 14.7619 -14.5482 -14.7618 -4.43686 14.5482 4.43688 0.0 +2346 3.35 2.65 131.25 17.7243 -20.5254 -17.7243 -3.76779 20.5254 3.7678 0.0 +2347 3.35 2.65 138.75 19.587 -25.2345 -19.587 -2.6757 25.2346 2.67568 0.0 +2348 3.35 2.65 146.25 20.4495 -28.5646 -20.4495 -1.38054 28.5646 1.38055 0.0 +2349 3.35 2.65 153.75 20.5999 -30.6433 -20.5999 -0.109613 30.6433 0.109611 0.0 +2350 3.35 2.65 161.25 20.3618 -31.7671 -20.3618 0.96685 31.767 -0.966847 0.0 +2351 3.35 2.65 168.75 20.022 -32.2781 -20.022 1.7383 32.278 -1.73826 0.0 +2352 3.35 2.65 176.25 19.7947 -32.4568 -19.7946 2.13939 32.4568 -2.13939 0.0 +2353 3.35 2.75 3.75 -623.075 -1035.97 623.075 3278.31 1035.97 -3278.31 0.0 +2354 3.35 2.75 11.25 -410.652 -765.022 410.652 1641.05 765.022 -1641.05 0.0 +2355 3.35 2.75 18.75 -187.486 -428.713 187.486 547.291 428.713 -547.291 0.0 +2356 3.35 2.75 26.25 -59.4311 -173.568 59.4311 133.12 173.568 -133.12 0.0 +2357 3.35 2.75 33.75 -17.2303 -35.1265 17.2302 31.786 35.1264 -31.786 0.0 +2358 3.35 2.75 41.25 -12.1098 17.1178 12.1099 13.8192 -17.1178 -13.8193 0.0 +2359 3.35 2.75 48.75 -10.4656 26.5604 10.4656 3.88378 -26.5604 -3.88377 0.0 +2360 3.35 2.75 56.25 -4.13597 22.6167 4.136 -5.48779 -22.6166 5.48779 0.0 +2361 3.35 2.75 63.75 3.31091 18.3493 -3.31091 -10.6986 -18.3493 10.6986 0.0 +2362 3.35 2.75 71.25 8.14692 16.4609 -8.14686 -11.4323 -16.4609 11.4323 0.0 +2363 3.35 2.75 78.75 9.44923 15.3065 -9.44926 -9.35408 -15.3065 9.35408 0.0 +2364 3.35 2.75 86.25 8.34302 13.115 -8.34302 -6.45209 -13.115 6.45209 0.0 +2365 3.35 2.75 93.75 6.73127 9.59264 -6.73125 -4.25534 -9.59267 4.25533 0.0 +2366 3.35 2.75 101.25 6.04641 5.36361 -6.04642 -3.28804 -5.36363 3.28804 0.0 +2367 3.35 2.75 108.75 6.5681 1.00824 -6.56803 -3.16383 -1.00821 3.16382 0.0 +2368 3.35 2.75 116.25 7.69424 -3.1996 -7.69426 -3.20291 3.19971 3.20288 0.0 +2369 3.35 2.75 123.75 8.6827 -7.07441 -8.68271 -2.95679 7.07435 2.9568 0.0 +2370 3.35 2.75 131.25 9.13874 -10.3765 -9.13876 -2.33529 10.3765 2.3353 0.0 +2371 3.35 2.75 138.75 9.04359 -12.8901 -9.04363 -1.46655 12.8901 1.46658 0.0 +2372 3.35 2.75 146.25 8.56433 -14.5486 -8.56434 -0.526226 14.5485 0.526253 0.0 +2373 3.35 2.75 153.75 7.89764 -15.464 -7.89766 0.348926 15.464 -0.348943 0.0 +2374 3.35 2.75 161.25 7.21578 -15.8591 -7.2158 1.07115 15.859 -1.0711 0.0 +2375 3.35 2.75 168.75 6.66389 -15.9703 -6.6639 1.58421 15.9702 -1.5842 0.0 +2376 3.35 2.75 176.25 6.3556 -15.9786 -6.35561 1.85074 15.9787 -1.85078 0.0 +2377 3.35 2.85 3.75 -772.698 -919.877 772.698 4708.12 919.877 -4708.12 0.0 +2378 3.35 2.85 11.25 -511.822 -669.074 511.822 2155.18 669.074 -2155.18 0.0 +2379 3.35 2.85 18.75 -243.045 -367.941 243.045 691.364 367.941 -691.364 0.0 +2380 3.35 2.85 26.25 -83.2742 -147.185 83.2742 166.912 147.185 -166.912 0.0 +2381 3.35 2.85 33.75 -22.8244 -33.6483 22.8244 37.1489 33.6483 -37.1488 0.0 +2382 3.35 2.85 41.25 -9.53454 5.8483 9.53452 13.5783 -5.8483 -13.5783 0.0 +2383 3.35 2.85 48.75 -6.09018 12.291 6.09017 4.14913 -12.291 -4.14911 0.0 +2384 3.35 2.85 56.25 -1.26771 10.0666 1.26769 -3.04808 -10.0666 3.04809 0.0 +2385 3.35 2.85 63.75 3.7759 8.1959 -3.77587 -6.37734 -8.19594 6.37731 0.0 +2386 3.35 2.85 71.25 6.89166 7.92994 -6.89164 -6.4809 -7.92993 6.48089 0.0 +2387 3.35 2.85 78.75 7.67029 7.93236 -7.67027 -5.01743 -7.93236 5.01743 0.0 +2388 3.35 2.85 86.25 6.86704 7.07559 -6.86708 -3.3556 -7.07557 3.3556 0.0 +2389 3.35 2.85 93.75 5.65228 5.32847 -5.65231 -2.30528 -5.32852 2.30528 0.0 +2390 3.35 2.85 101.25 4.87116 3.215 -4.87125 -1.98423 -3.21505 1.98422 0.0 +2391 3.35 2.85 108.75 4.63041 1.1067 -4.6304 -2.02318 -1.10679 2.0232 0.0 +2392 3.35 2.85 116.25 4.54443 -0.892094 -4.54436 -2.003 0.892026 2.00303 0.0 +2393 3.35 2.85 123.75 4.25373 -2.7196 -4.25376 -1.73147 2.7196 1.73148 0.0 +2394 3.35 2.85 131.25 3.67676 -4.24518 -3.67683 -1.23922 4.24515 1.23922 0.0 +2395 3.35 2.85 138.75 2.92527 -5.34331 -2.92524 -0.644988 5.34322 0.64504 0.0 +2396 3.35 2.85 146.25 2.13491 -5.99066 -2.135 -0.0510476 5.99066 0.051009 0.0 +2397 3.35 2.85 153.75 1.39275 -6.27569 -1.39282 0.483407 6.27566 -0.483401 0.0 +2398 3.35 2.85 161.25 0.754236 -6.34028 -0.754226 0.924147 6.34015 -0.924067 0.0 +2399 3.35 2.85 168.75 0.275676 -6.31398 -0.275689 1.24213 6.314 -1.24219 0.0 +2400 3.35 2.85 176.25 0.0164689 -6.28159 -0.0164513 1.40997 6.28154 -1.40995 0.0 +2401 3.35 2.95 3.75 -834.912 -728.644 834.912 6476.41 728.644 -6476.41 0.0 +2402 3.35 2.95 11.25 -547.497 -530.188 547.497 2613.47 530.188 -2613.47 0.0 +2403 3.35 2.95 18.75 -262.248 -290.02 262.248 793.304 290.02 -793.304 0.0 +2404 3.35 2.95 26.25 -91.3227 -113.901 91.3227 183.027 113.901 -183.027 0.0 +2405 3.35 2.95 33.75 -23.4608 -26.232 23.4608 35.3151 26.232 -35.3151 0.0 +2406 3.35 2.95 41.25 -6.66345 1.76515 6.66345 10.2484 -1.76515 -10.2484 0.0 +2407 3.35 2.95 48.75 -3.09293 5.49926 3.09291 2.9506 -5.49927 -2.95059 0.0 +2408 3.35 2.95 56.25 -0.128908 4.20301 0.128901 -1.8156 -4.20296 1.81563 0.0 +2409 3.35 2.95 63.75 2.69811 3.54905 -2.69809 -3.66338 -3.54904 3.66335 0.0 +2410 3.35 2.95 71.25 4.37067 3.76567 -4.37061 -3.47926 -3.76571 3.47927 0.0 +2411 3.35 2.95 78.75 4.78503 3.92124 -4.78501 -2.55161 -3.92135 2.55159 0.0 +2412 3.35 2.95 86.25 4.343 3.47426 -4.34301 -1.68279 -3.47427 1.6828 0.0 +2413 3.35 2.95 93.75 3.62999 2.57963 -3.62993 -1.22603 -2.57969 1.22603 0.0 +2414 3.35 2.95 101.25 3.06714 1.6304 -3.06715 -1.13714 -1.63033 1.13713 0.0 +2415 3.35 2.95 108.75 2.6714 0.806801 -2.67137 -1.16012 -0.806856 1.16013 0.0 +2416 3.35 2.95 116.25 2.22983 0.0794546 -2.22987 -1.08361 -0.0795543 1.0836 0.0 +2417 3.35 2.95 123.75 1.62198 -0.581679 -1.62197 -0.855095 0.581669 0.855109 0.0 +2418 3.35 2.95 131.25 0.911108 -1.12896 -0.911104 -0.532177 1.12888 0.532245 0.0 +2419 3.35 2.95 138.75 0.221326 -1.50232 -0.221315 -0.188004 1.50224 0.188057 0.0 +2420 3.35 2.95 146.25 -0.381126 -1.7 0.381078 0.137706 1.6999 -0.137646 0.0 +2421 3.35 2.95 153.75 -0.893851 -1.77735 0.893832 0.432684 1.77726 -0.432674 0.0 +2422 3.35 2.95 161.25 -1.32378 -1.80097 1.32382 0.687059 1.80096 -0.687066 0.0 +2423 3.35 2.95 168.75 -1.6499 -1.81175 1.64995 0.880202 1.81183 -0.880216 0.0 +2424 3.35 2.95 176.25 -1.82978 -1.81925 1.82977 0.985879 1.81919 -0.985873 0.0 +2425 3.35 3.05 3.75 -785.046 -461.717 785.046 8594.91 461.717 -8594.91 0.0 +2426 3.35 3.05 11.25 -505.888 -356.771 505.888 2934.01 356.771 -2934.01 0.0 +2427 3.35 3.05 18.75 -241.842 -203.918 241.842 839.22 203.918 -839.22 0.0 +2428 3.35 3.05 26.25 -83.9245 -81.0674 83.9245 182.984 81.0674 -182.984 0.0 +2429 3.35 3.05 33.75 -20.2141 -18.5085 20.2141 29.6979 18.5085 -29.6979 0.0 +2430 3.35 3.05 41.25 -4.1047 0.409433 4.10472 6.22641 -0.409475 -6.22641 0.0 +2431 3.35 3.05 48.75 -1.36284 2.35911 1.3628 1.60979 -2.35909 -1.60978 0.0 +2432 3.35 3.05 56.25 0.030431 1.62567 -0.030424 -1.01802 -1.6257 1.018 0.0 +2433 3.35 3.05 63.75 1.27646 1.51737 -1.27639 -1.88571 -1.51743 1.88574 0.0 +2434 3.35 3.05 71.25 2.00146 1.74382 -2.00153 -1.67715 -1.74388 1.67713 0.0 +2435 3.35 3.05 78.75 2.22947 1.7724 -2.22943 -1.1839 -1.77249 1.1839 0.0 +2436 3.35 3.05 86.25 2.09366 1.4585 -2.09372 -0.787813 -1.45856 0.787813 0.0 +2437 3.35 3.05 93.75 1.79746 1.00626 -1.79749 -0.60616 -1.00615 0.606162 0.0 +2438 3.35 3.05 101.25 1.51527 0.661229 -1.51529 -0.575074 -0.661245 0.575087 0.0 +2439 3.35 3.05 108.75 1.24058 0.468536 -1.24057 -0.561828 -0.468484 0.561787 0.0 +2440 3.35 3.05 116.25 0.876962 0.332896 -0.876938 -0.482689 -0.332964 0.482687 0.0 +2441 3.35 3.05 123.75 0.416156 0.186434 -0.416121 -0.336497 -0.18647 0.336515 0.0 +2442 3.35 3.05 131.25 -0.0499558 0.038764 0.0498225 -0.163924 -0.0389844 0.163982 0.0 +2443 3.35 3.05 138.75 -0.440256 -0.0796634 0.440301 0.00362958 0.0796422 -0.00361361 0.0 +2444 3.35 3.05 146.25 -0.749289 -0.169351 0.749274 0.161127 0.169574 -0.161167 0.0 +2445 3.35 3.05 153.75 -1.01485 -0.254878 1.01491 0.314525 0.254752 -0.314449 0.0 +2446 3.35 3.05 161.25 -1.25872 -0.351609 1.25877 0.460297 0.351661 -0.460329 0.0 +2447 3.35 3.05 168.75 -1.46132 -0.446415 1.46128 0.579664 0.446487 -0.579718 0.0 +2448 3.35 3.05 176.25 -1.5791 -0.506807 1.57912 0.64783 0.506772 -0.647769 0.0 +2449 3.35 3.15 3.75 -613.346 -128.944 613.346 10936.8 128.944 -10936.8 0.0 +2450 3.35 3.15 11.25 -388.42 -159.752 388.42 3039.67 159.752 -3039.67 0.0 +2451 3.35 3.15 18.75 -185.578 -114.971 185.578 822.812 114.971 -822.812 0.0 +2452 3.35 3.15 26.25 -64.0967 -51.2619 64.0967 169.928 51.2619 -169.928 0.0 +2453 3.35 3.15 33.75 -14.6003 -12.3908 14.6002 23.2626 12.3908 -23.2627 0.0 +2454 3.35 3.15 41.25 -2.15789 -0.18353 2.15785 3.0437 0.183543 -3.04367 0.0 +2455 3.35 3.15 48.75 -0.515911 0.863817 0.515956 0.688645 -0.863876 -0.688622 0.0 +2456 3.35 3.15 56.25 -0.10478 0.478921 0.1048 -0.434933 -0.478877 0.434918 0.0 +2457 3.35 3.15 63.75 0.278403 0.550597 -0.278425 -0.770867 -0.550582 0.770892 0.0 +2458 3.35 3.15 71.25 0.518182 0.679229 -0.518188 -0.658783 -0.679258 0.658773 0.0 +2459 3.35 3.15 78.75 0.661602 0.637382 -0.661573 -0.463196 -0.63745 0.463179 0.0 +2460 3.35 3.15 86.25 0.697289 0.449817 -0.697335 -0.319991 -0.449817 0.319985 0.0 +2461 3.35 3.15 93.75 0.640594 0.258804 -0.6406 -0.254833 -0.258796 0.254831 0.0 +2462 3.35 3.15 101.25 0.556527 0.18774 -0.556486 -0.235323 -0.187938 0.235367 0.0 +2463 3.35 3.15 108.75 0.446937 0.222191 -0.446909 -0.215213 -0.222297 0.215245 0.0 +2464 3.35 3.15 116.25 0.274348 0.26483 -0.274369 -0.168371 -0.264953 0.168437 0.0 +2465 3.35 3.15 123.75 0.0574631 0.256391 -0.0574175 -0.0982881 -0.25635 0.0982953 0.0 +2466 3.35 3.15 131.25 -0.138437 0.203868 0.138469 -0.0233365 -0.203754 0.023301 0.0 +2467 3.35 3.15 138.75 -0.278798 0.131654 0.27879 0.0462375 -0.131622 -0.0462824 0.0 +2468 3.35 3.15 146.25 -0.386441 0.0434165 0.386373 0.115347 -0.0435636 -0.115286 0.0 +2469 3.35 3.15 153.75 -0.50135 -0.0699762 0.50138 0.191887 0.0700475 -0.191868 0.0 +2470 3.35 3.15 161.25 -0.635272 -0.204478 0.635288 0.273074 0.204491 -0.273059 0.0 +2471 3.35 3.15 168.75 -0.76189 -0.331252 0.762029 0.343855 0.331256 -0.343819 0.0 +2472 3.35 3.15 176.25 -0.839967 -0.409418 0.839975 0.385429 0.409487 -0.385428 0.0 +2473 3.35 3.25 3.75 -331.119 235.647 331.119 12776.5 -235.647 -12776.5 0.0 +2474 3.35 3.25 11.25 -210.73 43.1724 210.73 2886.81 -43.1724 -2886.81 0.0 +2475 3.35 3.25 18.75 -103.557 -28.0167 103.557 746.774 28.0167 -746.774 0.0 +2476 3.35 3.25 26.25 -36.8542 -24.6146 36.8541 147.416 24.6146 -147.416 0.0 +2477 3.35 3.25 33.75 -8.31772 -7.63126 8.31767 17.7578 7.6313 -17.7578 0.0 +2478 3.35 3.25 41.25 -0.927756 -0.474989 0.927739 1.25145 0.474959 -1.25143 0.0 +2479 3.35 3.25 48.75 -0.171876 0.182322 0.171929 0.229436 -0.182338 -0.229375 0.0 +2480 3.35 3.25 56.25 -0.173447 -0.00784342 0.173479 -0.0821736 0.00784618 0.0821739 0.0 +2481 3.35 3.25 63.75 -0.109125 0.0713448 0.109065 -0.190602 -0.071458 0.190586 0.0 +2482 3.35 3.25 71.25 -0.051811 0.125665 0.0517963 -0.170553 -0.125602 0.170563 0.0 +2483 3.35 3.25 78.75 0.0349192 0.107932 -0.0348983 -0.12797 -0.107897 0.127947 0.0 +2484 3.35 3.25 86.25 0.109977 0.0525243 -0.109978 -0.0975017 -0.0525561 0.0974949 0.0 +2485 3.35 3.25 93.75 0.133592 0.00564846 -0.133572 -0.079523 -0.0054719 0.0795129 0.0 +2486 3.35 3.25 101.25 0.13514 0.0218498 -0.135139 -0.068635 -0.0218243 0.0686367 0.0 +2487 3.35 3.25 108.75 0.125808 0.0847814 -0.125742 -0.0608821 -0.0845929 0.0608698 0.0 +2488 3.35 3.25 116.25 0.0859804 0.127099 -0.0859118 -0.046674 -0.12691 0.0466421 0.0 +2489 3.35 3.25 123.75 0.0240101 0.116896 -0.0240258 -0.0218336 -0.116907 0.0218839 0.0 +2490 3.35 3.25 131.25 -0.0259337 0.0728231 0.0260029 0.00618536 -0.0729523 -0.00609409 0.0 +2491 3.35 3.25 138.75 -0.0524477 0.0198607 0.0523403 0.031086 -0.019903 -0.0310656 0.0 +2492 3.35 3.25 146.25 -0.0771902 -0.0394305 0.0771127 0.0560935 0.0392944 -0.0560811 0.0 +2493 3.35 3.25 153.75 -0.125327 -0.115249 0.125381 0.0868502 0.11537 -0.0868962 0.0 +2494 3.35 3.25 161.25 -0.197635 -0.207122 0.19763 0.12226 0.207294 -0.122357 0.0 +2495 3.35 3.25 168.75 -0.27075 -0.295144 0.270796 0.154148 0.295239 -0.154149 0.0 +2496 3.35 3.25 176.25 -0.316454 -0.349799 0.316406 0.172999 0.349655 -0.172891 0.0 +2497 3.35 3.35 3.75 21.6477 545.28 -21.6477 11815.8 -545.28 -11815.8 0.0 +2498 3.35 3.35 11.25 0.173729 218.755 -0.173719 2394.74 -218.755 -2394.74 0.0 +2499 3.35 3.35 18.75 -9.53806 48.3705 9.53809 598.087 -48.3705 -598.087 0.0 +2500 3.35 3.35 26.25 -7.66274 -1.12322 7.66276 113.819 1.12321 -113.819 0.0 +2501 3.35 3.35 33.75 -2.74384 -3.33129 2.74384 12.9293 3.33125 -12.9293 0.0 +2502 3.35 3.35 41.25 -0.346706 -0.421196 0.346694 0.581284 0.421155 -0.581292 0.0 +2503 3.35 3.35 48.75 -0.0597258 -0.052617 0.0597015 0.0549515 0.0526707 -0.0549747 0.0 +2504 3.35 3.35 56.25 -0.126882 -0.137188 0.126857 0.0379118 0.137277 -0.0378934 0.0 +2505 3.35 3.35 63.75 -0.109892 -0.0878689 0.109868 0.00253737 0.0878685 -0.00255598 0.0 +2506 3.35 3.35 71.25 -0.0980488 -0.073463 0.0980418 -0.0105894 0.0734524 0.0105771 0.0 +2507 3.35 3.35 78.75 -0.0669262 -0.0528742 0.0669078 -0.0108983 0.0530139 0.0109302 0.0 +2508 3.35 3.35 86.25 -0.0219711 -0.0291652 0.0219318 -0.0154295 0.0291951 0.0154292 0.0 +2509 3.35 3.35 93.75 0.00146699 -0.0207303 -0.00146179 -0.0140867 0.020679 0.0140912 0.0 +2510 3.35 3.35 101.25 0.0168709 0.00290498 -0.0169225 -0.00898105 -0.00281588 0.00896964 0.0 +2511 3.35 3.35 108.75 0.0340663 0.0389815 -0.0340623 -0.0103442 -0.039102 0.0103711 0.0 +2512 3.35 3.35 116.25 0.0352042 0.0499497 -0.0351821 -0.0111656 -0.0499387 0.0111689 0.0 +2513 3.35 3.35 123.75 0.0178821 0.0273981 -0.0178368 -0.0038908 -0.0275323 0.00391568 0.0 +2514 3.35 3.35 131.25 0.00245117 -0.00157526 -0.00237029 0.00543782 0.0017713 -0.00545999 0.0 +2515 3.35 3.35 138.75 -0.000452681 -0.0169013 0.000469283 0.00962862 0.0169401 -0.00965926 0.0 +2516 3.35 3.35 146.25 -0.000710544 -0.0221597 0.000754182 0.0101186 0.0223253 -0.0102137 0.0 +2517 3.35 3.35 153.75 -0.0111111 -0.0323046 0.011189 0.0113797 0.0322223 -0.0112957 0.0 +2518 3.35 3.35 161.25 -0.0318368 -0.0542513 0.0318153 0.0143177 0.0540301 -0.014212 0.0 +2519 3.35 3.35 168.75 -0.0531774 -0.0809936 0.0531282 0.0170487 0.0810135 -0.0171249 0.0 +2520 3.35 3.35 176.25 -0.0660009 -0.0992697 0.0659877 0.01838 0.0992028 -0.0183637 0.0 +2521 3.35 3.45 3.75 264.52 547.577 -264.52 6202.93 -547.577 -6202.93 0.0 +2522 3.35 3.45 11.25 146.664 252.974 -146.664 1327.09 -252.974 -1327.09 0.0 +2523 3.35 3.45 18.75 55.5979 76.7316 -55.5979 320.33 -76.7316 -320.33 0.0 +2524 3.35 3.45 26.25 12.0322 12.2347 -12.0322 58.3259 -12.2346 -58.3259 0.0 +2525 3.35 3.45 33.75 0.596069 0.246217 -0.596031 6.50975 -0.246209 -6.50972 0.0 +2526 3.35 3.45 41.25 -0.174085 -0.0773709 0.174074 0.316004 0.0773448 -0.316022 0.0 +2527 3.35 3.45 48.75 -0.00445633 -0.0860244 0.00448977 0.0121395 0.0860192 -0.0120971 0.0 +2528 3.35 3.45 56.25 -0.0477545 -0.104883 0.0478083 0.0286837 0.104818 -0.0286912 0.0 +2529 3.35 3.45 63.75 -0.0332506 -0.0586084 0.0333016 0.00627557 0.0586119 -0.0062805 0.0 +2530 3.35 3.45 71.25 -0.0281034 -0.0608434 0.0280864 -0.00101144 0.0608456 0.00103223 0.0 +2531 3.35 3.45 78.75 -0.0318181 -0.0457338 0.0317996 0.00287139 0.0457793 -0.00287648 0.0 +2532 3.35 3.45 86.25 -0.0190638 -0.0189326 0.0190873 -0.00282309 0.0188606 0.00282802 0.0 +2533 3.35 3.45 93.75 -0.00845602 -0.00564765 0.00846357 -0.00258802 0.00569123 0.00258276 0.0 +2534 3.35 3.45 101.25 -0.000108637 0.0104483 0.000114753 0.00269483 -0.0103655 -0.00269193 0.0 +2535 3.35 3.45 108.75 0.0096153 0.0272037 -0.00961347 0.00262296 -0.0272254 -0.00260619 0.0 +2536 3.35 3.45 116.25 0.00852246 0.0258295 -0.00856241 0.0019054 -0.0259022 -0.00189501 0.0 +2537 3.35 3.45 123.75 -0.00485077 0.0100252 0.00491377 0.00479164 -0.010035 -0.00474465 0.0 +2538 3.35 3.45 131.25 -0.0151032 -0.00124015 0.0150869 0.00590864 0.00128885 -0.00595605 0.0 +2539 3.35 3.45 138.75 -0.0116773 0.000794051 0.0116531 0.00155451 -0.000693976 -0.00161011 0.0 +2540 3.35 3.45 146.25 0.000951708 0.00984726 -0.000976147 -0.00547841 -0.00985363 0.00546737 0.0 +2541 3.35 3.45 153.75 0.0141348 0.0178974 -0.0141348 -0.0120161 -0.0179225 0.0120171 0.0 +2542 3.35 3.45 161.25 0.024418 0.0223568 -0.0244107 -0.0180532 -0.022375 0.0180171 0.0 +2543 3.35 3.45 168.75 0.0321657 0.0245203 -0.0321044 -0.0239933 -0.0245871 0.0240198 0.0 +2544 3.35 3.45 176.25 0.0366433 0.0254514 -0.0366767 -0.0281044 -0.0255168 0.0281336 0.0 +2545 3.35 3.55 3.75 212.112 270.322 -212.112 1633.44 -270.322 -1633.44 0.0 +2546 3.35 3.55 11.25 122.019 134.508 -122.019 394.591 -134.508 -394.591 0.0 +2547 3.35 3.55 18.75 47.7974 44.519 -47.7974 89.0516 -44.519 -89.0516 0.0 +2548 3.35 3.55 26.25 11.0171 8.96418 -11.0171 14.3465 -8.96418 -14.3466 0.0 +2549 3.35 3.55 33.75 0.785538 1.00667 -0.785533 1.3707 -1.00666 -1.37071 0.0 +2550 3.35 3.55 41.25 -0.100275 0.111814 0.100273 0.063653 -0.111807 -0.0636804 0.0 +2551 3.35 3.55 48.75 0.0358723 -0.0504078 -0.0358729 0.0207167 0.0504272 -0.0207188 0.0 +2552 3.35 3.55 56.25 -0.0107991 -0.0545945 0.0108077 0.0260469 0.0545759 -0.0260665 0.0 +2553 3.35 3.55 63.75 -0.0137965 -0.0162173 0.01382 0.00310984 0.0162029 -0.00312469 0.0 +2554 3.35 3.55 71.25 -0.00443791 -0.0176794 0.00444316 -0.0030039 0.0176744 0.00300773 0.0 +2555 3.35 3.55 78.75 -0.00661178 -0.0194646 0.00662503 -0.000183672 0.0194799 0.000190292 0.0 +2556 3.35 3.55 86.25 -0.0044624 -0.0145146 0.00445811 -0.00308715 0.0145483 0.00308949 0.0 +2557 3.35 3.55 93.75 -0.00201713 -0.0103082 0.00203467 -0.0034837 0.0103487 0.00348302 0.0 +2558 3.35 3.55 101.25 0.000612684 -0.00214047 -0.000633647 -0.00170294 0.00208873 0.00170816 0.0 +2559 3.35 3.55 108.75 0.00492679 0.00544074 -0.00492725 -0.000964504 -0.00547196 0.000980009 0.0 +2560 3.35 3.55 116.25 0.00552459 0.00494329 -0.00551079 0.00128236 -0.00490754 -0.00128794 0.0 +2561 3.35 3.55 123.75 0.00248381 -0.000309276 -0.00248587 0.00443651 0.000330766 -0.00443577 0.0 +2562 3.35 3.55 131.25 0.00307595 -0.00427668 -0.00308807 0.00457978 0.00431048 -0.00460838 0.0 +2563 3.35 3.55 138.75 0.0100829 -0.00649667 -0.0100649 0.00162916 0.00646752 -0.00160639 0.0 +2564 3.35 3.55 146.25 0.0183636 -0.0087324 -0.0183591 -0.00101933 0.00878923 0.000998688 0.0 +2565 3.35 3.55 153.75 0.0223417 -0.00978813 -0.0223341 -0.00163428 0.00977234 0.00164318 0.0 +2566 3.35 3.55 161.25 0.0213234 -0.00730229 -0.0213443 -0.0014192 0.00724781 0.00144804 0.0 +2567 3.35 3.55 168.75 0.0183265 -0.00180711 -0.0183314 -0.00178155 0.00182466 0.00177075 0.0 +2568 3.35 3.55 176.25 0.0161793 0.00277081 -0.0161889 -0.00245834 -0.00278613 0.00245868 0.0 +2569 3.35 3.65 3.75 34.2993 31.2111 -34.2993 99.1827 -31.2111 -99.1827 0.0 +2570 3.35 3.65 11.25 20.1073 16.1249 -20.1073 25.0862 -16.1249 -25.0862 0.0 +2571 3.35 3.65 18.75 7.81038 5.38483 -7.81038 4.29487 -5.38483 -4.29487 0.0 +2572 3.35 3.65 26.25 1.72232 1.10266 -1.72232 0.220387 -1.10265 -0.220388 0.0 +2573 3.35 3.65 33.75 0.0886792 0.151586 -0.0886799 -0.0820027 -0.151586 0.0820019 0.0 +2574 3.35 3.65 41.25 -0.0173171 0.0309048 0.0173154 -0.015518 -0.0309058 0.0155196 0.0 +2575 3.35 3.65 48.75 0.0101661 -0.00286499 -0.0101673 0.00763683 0.00286567 -0.00763753 0.0 +2576 3.35 3.65 56.25 -0.002689 -0.00624694 0.00268935 0.0083081 0.00624704 -0.00830852 0.0 +2577 3.35 3.65 63.75 -0.00312949 0.000414859 0.00313187 0.00248767 -0.000415121 -0.00248719 0.0 +2578 3.35 3.65 71.25 0.00176759 0.00183364 -0.00176593 0.000912355 -0.00183059 -0.000912314 0.0 +2579 3.35 3.65 78.75 0.00272836 0.00157348 -0.00272759 0.00117466 -0.00157332 -0.00117415 0.0 +2580 3.35 3.65 86.25 0.00159309 0.000928734 -0.00159386 0.000236076 -0.000929755 -0.000236263 0.0 +2581 3.35 3.65 93.75 -8.27674e-05 0.000144333 8.23358e-05 -0.00112934 -0.000145183 0.00112914 0.0 +2582 3.35 3.65 101.25 -0.000947847 0.000224482 0.00094892 -0.00225916 -0.000225888 0.00225973 0.0 +2583 3.35 3.65 108.75 -0.000863792 0.000432852 0.000864512 -0.00237019 -0.000431765 0.0023699 0.0 +2584 3.35 3.65 116.25 -0.000961541 -5.64864e-05 0.000960868 -0.0011264 6.07289e-05 0.00112608 0.0 +2585 3.35 3.65 123.75 -0.00127243 -0.000805706 0.0012707 0.000252729 0.000806025 -0.000253886 0.0 +2586 3.35 3.65 131.25 -0.000913381 -0.00130653 0.000910966 0.000474326 0.00130583 -0.000474541 0.0 +2587 3.35 3.65 138.75 -5.53154e-05 -0.00154588 5.78325e-05 -0.000286174 0.00155054 0.000285032 0.0 +2588 3.35 3.65 146.25 -6.51777e-05 -0.00124019 6.5744e-05 -0.000995048 0.00124163 0.000994467 0.0 +2589 3.35 3.65 153.75 -0.0019038 0.00032226 0.00190333 -0.00107275 -0.000320901 0.00107123 0.0 +2590 3.35 3.65 161.25 -0.00517932 0.00335224 0.00517862 -0.000703318 -0.00335729 0.000705883 0.0 +2591 3.35 3.65 168.75 -0.00853589 0.00691614 0.00853695 -0.000307448 -0.00691271 0.000304936 0.0 +2592 3.35 3.65 176.25 -0.0106065 0.00934073 0.0106054 -0.000100664 -0.0093421 0.000101267 0.0 +2593 3.45 2.55 3.75 -306.256 -630.26 306.256 712.027 630.26 -712.027 0.0 +2594 3.45 2.55 11.25 -241.643 -460.837 241.643 436.705 460.837 -436.705 0.0 +2595 3.45 2.55 18.75 -163.644 -227.704 163.644 196.914 227.704 -196.914 0.0 +2596 3.45 2.55 26.25 -109.293 -33.3416 109.293 89.2043 33.3416 -89.2043 0.0 +2597 3.45 2.55 33.75 -79.3847 79.4725 79.3847 51.6528 -79.4725 -51.6528 0.0 +2598 3.45 2.55 41.25 -58.4527 119.272 58.4527 27.3787 -119.272 -27.3787 0.0 +2599 3.45 2.55 48.75 -36.2063 116.335 36.2063 1.24536 -116.335 -1.24536 0.0 +2600 3.45 2.55 56.25 -12.877 98.7088 12.877 -21.3417 -98.7088 21.3417 0.0 +2601 3.45 2.55 63.75 6.39264 81.7834 -6.39265 -34.2469 -81.7834 34.2469 0.0 +2602 3.45 2.55 71.25 17.6707 68.9207 -17.6707 -36.3618 -68.9207 36.3618 0.0 +2603 3.45 2.55 78.75 20.7496 57.5203 -20.7496 -30.7183 -57.5203 30.7183 0.0 +2604 3.45 2.55 86.25 18.6942 44.7959 -18.6942 -22.1495 -44.7959 22.1495 0.0 +2605 3.45 2.55 93.75 15.7399 30.0692 -15.7399 -14.7587 -30.0692 14.7587 0.0 +2606 3.45 2.55 101.25 14.9561 14.1711 -14.9561 -10.3261 -14.1711 10.3261 0.0 +2607 3.45 2.55 108.75 17.1133 -1.75859 -17.1132 -8.43042 1.75863 8.43042 0.0 +2608 3.45 2.55 116.25 21.1653 -16.7758 -21.1653 -7.6838 16.7758 7.6838 0.0 +2609 3.45 2.55 123.75 25.5091 -30.1056 -25.509 -6.89494 30.1057 6.89493 0.0 +2610 3.45 2.55 131.25 28.9655 -41.1155 -28.9654 -5.54039 41.1155 5.54038 0.0 +2611 3.45 2.55 138.75 31.0793 -49.4383 -31.0794 -3.65858 49.4383 3.65857 0.0 +2612 3.45 2.55 146.25 31.9503 -55.0945 -31.9503 -1.54808 55.0945 1.54807 0.0 +2613 3.45 2.55 153.75 31.9458 -58.4765 -31.9458 0.46791 58.4765 -0.467925 0.0 +2614 3.45 2.55 161.25 31.4914 -60.2005 -31.4914 2.14501 60.2005 -2.14503 0.0 +2615 3.45 2.55 168.75 30.9607 -60.9133 -30.9607 3.33031 60.9133 -3.3303 0.0 +2616 3.45 2.55 176.25 30.6245 -61.1297 -30.6245 3.94075 61.1298 -3.94076 0.0 +2617 3.45 2.65 3.75 -410.404 -684.119 410.404 1124.97 684.119 -1124.97 0.0 +2618 3.45 2.65 11.25 -315.445 -504.168 315.445 663.12 504.168 -663.12 0.0 +2619 3.45 2.65 18.75 -200.158 -265.393 200.158 285.214 265.393 -285.214 0.0 +2620 3.45 2.65 26.25 -117.759 -74.4043 117.759 118.865 74.4044 -118.865 0.0 +2621 3.45 2.65 33.75 -72.7391 32.0266 72.7391 62.0115 -32.0266 -62.0115 0.0 +2622 3.45 2.65 41.25 -46.6794 69.0359 46.6794 32.6288 -69.0359 -32.6288 0.0 +2623 3.45 2.65 48.75 -25.0296 68.799 25.0296 6.85355 -68.799 -6.85356 0.0 +2624 3.45 2.65 56.25 -4.70437 57.3573 4.70435 -12.9243 -57.3573 12.9243 0.0 +2625 3.45 2.65 63.75 11.3837 47.5257 -11.3838 -22.9609 -47.5257 22.9609 0.0 +2626 3.45 2.65 71.25 20.5482 41.3831 -20.5482 -23.9869 -41.3831 23.9869 0.0 +2627 3.45 2.65 78.75 22.8085 36.193 -22.8085 -19.5196 -36.193 19.5196 0.0 +2628 3.45 2.65 86.25 20.6545 29.4327 -20.6545 -13.6165 -29.4327 13.6165 0.0 +2629 3.45 2.65 93.75 17.4317 20.6221 -17.4318 -9.11551 -20.6221 9.11551 0.0 +2630 3.45 2.65 101.25 15.4934 10.6053 -15.4934 -6.83936 -10.6052 6.83936 0.0 +2631 3.45 2.65 108.75 15.3634 0.398853 -15.3634 -6.08122 -0.398839 6.08122 0.0 +2632 3.45 2.65 116.25 16.2491 -9.23221 -16.2491 -5.71107 9.23223 5.71106 0.0 +2633 3.45 2.65 123.75 17.0991 -17.6958 -17.0991 -4.98277 17.6958 4.98277 0.0 +2634 3.45 2.65 131.25 17.2969 -24.5169 -17.2969 -3.71694 24.5169 3.71693 0.0 +2635 3.45 2.65 138.75 16.7536 -29.4367 -16.7536 -2.09401 29.4367 2.09401 0.0 +2636 3.45 2.65 146.25 15.6864 -32.5095 -15.6864 -0.393538 32.5095 0.393535 0.0 +2637 3.45 2.65 153.75 14.3972 -34.0775 -14.3972 1.15395 34.0775 -1.15396 0.0 +2638 3.45 2.65 161.25 13.1634 -34.6385 -13.1634 2.40176 34.6385 -2.40176 0.0 +2639 3.45 2.65 168.75 12.2071 -34.6906 -12.2071 3.26815 34.6906 -3.26815 0.0 +2640 3.45 2.65 176.25 11.6868 -34.6153 -11.6868 3.7106 34.6154 -3.7106 0.0 +2641 3.45 2.75 3.75 -497.255 -677 497.255 1652.99 677 -1652.99 0.0 +2642 3.45 2.75 11.25 -373.691 -495.677 373.691 915.601 495.677 -915.601 0.0 +2643 3.45 2.75 18.75 -225.553 -263.706 225.553 365.966 263.706 -365.966 0.0 +2644 3.45 2.75 26.25 -119.766 -85.9838 119.766 136.334 85.9838 -136.334 0.0 +2645 3.45 2.75 33.75 -63.267 7.86172 63.267 62.4019 -7.86172 -62.4019 0.0 +2646 3.45 2.75 41.25 -34.7214 38.5117 34.7215 30.9646 -38.5117 -30.9646 0.0 +2647 3.45 2.75 48.75 -15.6402 38.6905 15.6402 7.75474 -38.6905 -7.75474 0.0 +2648 3.45 2.75 56.25 0.200898 31.3646 -0.200906 -8.25822 -31.3646 8.25823 0.0 +2649 3.45 2.75 63.75 12.1025 26.2015 -12.1025 -15.3813 -26.2016 15.3813 0.0 +2650 3.45 2.75 71.25 18.645 23.9679 -18.645 -15.4998 -23.9679 15.4998 0.0 +2651 3.45 2.75 78.75 20.0366 22.0995 -20.0365 -12.0647 -22.0994 12.0647 0.0 +2652 3.45 2.75 86.25 18.0975 18.6666 -18.0975 -8.18733 -18.6667 8.18733 0.0 +2653 3.45 2.75 93.75 15.203 13.548 -15.2031 -5.61947 -13.548 5.61947 0.0 +2654 3.45 2.75 101.25 12.9731 7.59374 -12.9732 -4.55604 -7.59372 4.55604 0.0 +2655 3.45 2.75 108.75 11.7095 1.61177 -11.7095 -4.26673 -1.61172 4.26671 0.0 +2656 3.45 2.75 116.25 10.8678 -3.90594 -10.8678 -3.95972 3.9059 3.95974 0.0 +2657 3.45 2.75 123.75 9.86364 -8.62299 -9.86364 -3.25525 8.62305 3.25522 0.0 +2658 3.45 2.75 131.25 8.48939 -12.2677 -8.48935 -2.17621 12.2677 2.1762 0.0 +2659 3.45 2.75 138.75 6.8561 -14.7058 -6.85612 -0.925779 14.7058 0.925792 0.0 +2660 3.45 2.75 146.25 5.17617 -16.0173 -5.17617 0.29668 16.0172 -0.296656 0.0 +2661 3.45 2.75 153.75 3.62928 -16.4706 -3.62927 1.36272 16.4706 -1.36274 0.0 +2662 3.45 2.75 161.25 2.34356 -16.418 -2.34357 2.20438 16.4181 -2.2044 0.0 +2663 3.45 2.75 168.75 1.41823 -16.1869 -1.41824 2.78491 16.1869 -2.7849 0.0 +2664 3.45 2.75 176.25 0.93231 -16.012 -0.932328 3.08139 16.012 -3.0814 0.0 +2665 3.45 2.85 3.75 -548.003 -614.565 548.003 2304.07 614.565 -2304.07 0.0 +2666 3.45 2.85 11.25 -403.385 -446.114 403.385 1173.83 446.114 -1173.83 0.0 +2667 3.45 2.85 18.75 -233.959 -236.004 233.959 430.61 236.004 -430.61 0.0 +2668 3.45 2.85 26.25 -114.291 -80.069 114.291 141.231 80.069 -141.231 0.0 +2669 3.45 2.85 33.75 -52.1051 -2.02399 52.1051 55.1217 2.02396 -55.1216 0.0 +2670 3.45 2.85 41.25 -24.0012 21.2002 24.0012 25.0552 -21.2002 -25.0552 0.0 +2671 3.45 2.85 48.75 -8.75879 20.9185 8.75874 6.24251 -20.9185 -6.2425 0.0 +2672 3.45 2.85 56.25 2.17439 16.3646 -2.17443 -5.56933 -16.3647 5.56933 0.0 +2673 3.45 2.85 63.75 9.87494 14.0522 -9.87497 -10.1202 -14.0522 10.1202 0.0 +2674 3.45 2.85 71.25 13.9611 13.6826 -13.9611 -9.68958 -13.6825 9.68959 0.0 +2675 3.45 2.85 78.75 14.7195 13.1469 -14.7196 -7.20381 -13.1468 7.20382 0.0 +2676 3.45 2.85 86.25 13.2825 11.2688 -13.2825 -4.80907 -11.2688 4.80907 0.0 +2677 3.45 2.85 93.75 11.1137 8.28982 -11.1137 -3.43822 -8.28984 3.43822 0.0 +2678 3.45 2.85 101.25 9.19959 4.99293 -9.19962 -2.96627 -4.99292 2.96627 0.0 +2679 3.45 2.85 108.75 7.69011 1.9132 -7.69008 -2.80506 -1.91323 2.80506 0.0 +2680 3.45 2.85 116.25 6.26738 -0.754121 -6.26738 -2.48465 0.754107 2.48465 0.0 +2681 3.45 2.85 123.75 4.69302 -2.92053 -4.69298 -1.87011 2.92052 1.87014 0.0 +2682 3.45 2.85 131.25 3.00043 -4.49316 -3.00046 -1.0617 4.4931 1.0617 0.0 +2683 3.45 2.85 138.75 1.35896 -5.43071 -1.35895 -0.214639 5.4307 0.21465 0.0 +2684 3.45 2.85 146.25 -0.0975721 -5.80953 0.0975683 0.564043 5.80952 -0.564042 0.0 +2685 3.45 2.85 153.75 -1.31554 -5.80487 1.31554 1.22538 5.80502 -1.22545 0.0 +2686 3.45 2.85 161.25 -2.27717 -5.61838 2.27719 1.74807 5.6184 -1.74807 0.0 +2687 3.45 2.85 168.75 -2.95565 -5.41309 2.95571 2.11405 5.41315 -2.11407 0.0 +2688 3.45 2.85 176.25 -3.31048 -5.28882 3.31047 2.30378 5.2888 -2.30378 0.0 +2689 3.45 2.95 3.75 -544.922 -497.061 544.922 3078.39 497.061 -3078.39 0.0 +2690 3.45 2.95 11.25 -393.552 -362.493 393.552 1406.5 362.493 -1406.5 0.0 +2691 3.45 2.95 18.75 -221.236 -192.412 221.236 470.974 192.412 -470.974 0.0 +2692 3.45 2.95 26.25 -101.063 -66.0352 101.063 134.97 66.0352 -134.97 0.0 +2693 3.45 2.95 33.75 -40.2469 -4.86193 40.2469 43.3621 4.86195 -43.3621 0.0 +2694 3.45 2.95 41.25 -15.2898 11.6213 15.2897 17.5126 -11.6213 -17.5126 0.0 +2695 3.45 2.95 48.75 -4.33523 10.905 4.3352 4.04329 -10.905 -4.04327 0.0 +2696 3.45 2.95 56.25 2.18714 8.24837 -2.1872 -3.74017 -8.24831 3.74018 0.0 +2697 3.45 2.95 63.75 6.40955 7.51416 -6.40948 -6.31275 -7.51421 6.31275 0.0 +2698 3.45 2.95 71.25 8.60941 7.77106 -8.60947 -5.71424 -7.77112 5.71422 0.0 +2699 3.45 2.95 78.75 9.03579 7.52495 -9.03581 -4.08358 -7.52497 4.08358 0.0 +2700 3.45 2.95 86.25 8.21402 6.29483 -8.21403 -2.72405 -6.29472 2.72405 0.0 +2701 3.45 2.95 93.75 6.87838 4.54861 -6.87836 -2.03984 -4.54871 2.03984 0.0 +2702 3.45 2.95 101.25 5.55629 2.91176 -5.55627 -1.81705 -2.91174 1.81705 0.0 +2703 3.45 2.95 108.75 4.32565 1.64201 -4.32569 -1.67096 -1.6421 1.67098 0.0 +2704 3.45 2.95 116.25 3.04826 0.69376 -3.04833 -1.37414 -0.693725 1.37412 0.0 +2705 3.45 2.95 123.75 1.69501 -0.0160375 -1.69503 -0.916383 0.0161119 0.916364 0.0 +2706 3.45 2.95 131.25 0.392887 -0.501719 -0.392925 -0.394265 0.501627 0.394291 0.0 +2707 3.45 2.95 138.75 -0.724329 -0.76263 0.724304 0.105035 0.762673 -0.105085 0.0 +2708 3.45 2.95 146.25 -1.61972 -0.843823 1.61969 0.545164 0.843697 -0.545116 0.0 +2709 3.45 2.95 153.75 -2.33022 -0.828516 2.33023 0.921858 0.828524 -0.921868 0.0 +2710 3.45 2.95 161.25 -2.89222 -0.792299 2.89228 1.23178 0.792409 -1.2318 0.0 +2711 3.45 2.95 168.75 -3.30112 -0.771646 3.30113 1.45896 0.771608 -1.45895 0.0 +2712 3.45 2.95 176.25 -3.52114 -0.766502 3.52118 1.58062 0.766532 -1.5806 0.0 +2713 3.45 3.05 3.75 -475.314 -322.42 475.314 3963.8 322.42 -3963.8 0.0 +2714 3.45 3.05 11.25 -338.348 -249.248 338.348 1573.32 249.248 -1573.32 0.0 +2715 3.45 3.05 18.75 -186.445 -139.031 186.445 480.819 139.031 -480.819 0.0 +2716 3.45 3.05 26.25 -81.0201 -49.399 81.0201 120.377 49.399 -120.377 0.0 +2717 3.45 3.05 33.75 -28.6328 -5.08278 28.6327 30.5097 5.08277 -30.5097 0.0 +2718 3.45 3.05 41.25 -8.82638 6.11139 8.82637 10.4404 -6.1114 -10.4404 0.0 +2719 3.45 3.05 48.75 -1.85343 5.32625 1.85346 2.16403 -5.32623 -2.164 0.0 +2720 3.45 3.05 56.25 1.35086 3.92765 -1.35083 -2.2841 -3.92766 2.2841 0.0 +2721 3.45 3.05 63.75 3.18303 3.93111 -3.18308 -3.54526 -3.93104 3.54527 0.0 +2722 3.45 3.05 71.25 4.18326 4.23744 -4.18318 -3.05394 -4.23741 3.05394 0.0 +2723 3.45 3.05 78.75 4.49258 3.9582 -4.49266 -2.12863 -3.95825 2.12861 0.0 +2724 3.45 3.05 86.25 4.19958 3.07628 -4.19957 -1.44525 -3.07631 1.44525 0.0 +2725 3.45 3.05 93.75 3.55703 2.09269 -3.55702 -1.12965 -2.09265 1.12965 0.0 +2726 3.45 3.05 101.25 2.82082 1.42577 -2.82082 -1.00836 -1.42574 1.00835 0.0 +2727 3.45 3.05 108.75 2.05335 1.12201 -2.0533 -0.879428 -1.12204 0.879438 0.0 +2728 3.45 3.05 116.25 1.22927 1.00436 -1.22931 -0.659137 -1.00432 0.659097 0.0 +2729 3.45 3.05 123.75 0.406034 0.922498 -0.406042 -0.375131 -0.922546 0.375153 0.0 +2730 3.45 3.05 131.25 -0.296186 0.832273 0.296225 -0.0883048 -0.832251 0.0882832 0.0 +2731 3.45 3.05 138.75 -0.814568 0.737363 0.814575 0.167299 -0.7374 -0.167276 0.0 +2732 3.45 3.05 146.25 -1.18502 0.630537 1.18498 0.392395 -0.630556 -0.392405 0.0 +2733 3.45 3.05 153.75 -1.48257 0.494496 1.48259 0.5978 -0.494437 -0.597808 0.0 +2734 3.45 3.05 161.25 -1.74881 0.331167 1.74885 0.781687 -0.331182 -0.781664 0.0 +2735 3.45 3.05 168.75 -1.96879 0.175253 1.96874 0.925742 -0.175235 -0.925772 0.0 +2736 3.45 3.05 176.25 -2.0967 0.0786764 2.09672 1.00588 -0.0786713 -1.00589 0.0 +2737 3.45 3.15 3.75 -335.15 -93.6243 335.15 4919.2 93.6243 -4919.2 0.0 +2738 3.45 3.15 11.25 -239.412 -112.098 239.412 1631.97 112.098 -1631.97 0.0 +2739 3.45 3.15 18.75 -132.594 -79.3632 132.594 457.179 79.3632 -457.179 0.0 +2740 3.45 3.15 26.25 -56.3887 -32.3191 56.3887 100.818 32.3191 -100.818 0.0 +2741 3.45 3.15 33.75 -18.16 -4.51131 18.1601 19.3237 4.51132 -19.3237 0.0 +2742 3.45 3.15 41.25 -4.4854 2.78229 4.48539 5.12234 -2.78226 -5.12233 0.0 +2743 3.45 3.15 48.75 -0.65816 2.23549 0.65826 0.957979 -2.23558 -0.957965 0.0 +2744 3.45 3.15 56.25 0.506275 1.58325 -0.506256 -1.13658 -1.58328 1.13657 0.0 +2745 3.45 3.15 63.75 1.03096 1.81098 -1.03093 -1.6632 -1.811 1.66321 0.0 +2746 3.45 3.15 71.25 1.41183 2.0053 -1.4118 -1.38913 -2.00536 1.38912 0.0 +2747 3.45 3.15 78.75 1.68372 1.73689 -1.68371 -0.965934 -1.73688 0.965929 0.0 +2748 3.45 3.15 86.25 1.70752 1.16763 -1.70751 -0.682141 -1.16765 0.682142 0.0 +2749 3.45 3.15 93.75 1.49569 0.679886 -1.49564 -0.555736 -0.679951 0.555736 0.0 +2750 3.45 3.15 101.25 1.17836 0.506082 -1.17831 -0.491039 -0.506091 0.491053 0.0 +2751 3.45 3.15 108.75 0.820869 0.586875 -0.820847 -0.406929 -0.586908 0.406931 0.0 +2752 3.45 3.15 116.25 0.442639 0.726307 -0.442661 -0.282046 -0.726397 0.28205 0.0 +2753 3.45 3.15 123.75 0.104502 0.791195 -0.10453 -0.138832 -0.791224 0.138815 0.0 +2754 3.45 3.15 131.25 -0.122088 0.757803 0.122111 -0.00554787 -0.757786 0.00557081 0.0 +2755 3.45 3.15 138.75 -0.233371 0.647708 0.233317 0.11009 -0.647633 -0.110127 0.0 +2756 3.45 3.15 146.25 -0.294334 0.47602 0.294323 0.218656 -0.476048 -0.218642 0.0 +2757 3.45 3.15 153.75 -0.374289 0.252194 0.374305 0.329856 -0.252147 -0.329913 0.0 +2758 3.45 3.15 161.25 -0.492985 0.00374022 0.493045 0.439147 -0.00376578 -0.439083 0.0 +2759 3.45 3.15 168.75 -0.618588 -0.216468 0.618562 0.529275 0.216442 -0.529286 0.0 +2760 3.45 3.15 176.25 -0.699206 -0.346872 0.699206 0.580539 0.346963 -0.580578 0.0 +2761 3.45 3.25 3.75 -131.986 172.423 131.986 5807.16 -172.423 -5807.16 0.0 +2762 3.45 3.25 11.25 -106.676 37.9086 106.676 1550.79 -37.9086 -1550.79 0.0 +2763 3.45 3.25 18.75 -66.3639 -16.7646 66.364 401.081 16.7646 -401.081 0.0 +2764 3.45 3.25 26.25 -30.3473 -15.2048 30.3473 79.1321 15.2048 -79.1321 0.0 +2765 3.45 3.25 33.75 -9.59735 -3.38585 9.59735 11.2832 3.38583 -11.2832 0.0 +2766 3.45 3.25 41.25 -1.92176 0.888505 1.92175 1.94054 -0.88848 -1.94058 0.0 +2767 3.45 3.25 48.75 -0.186459 0.662911 0.186482 0.346642 -0.662898 -0.346709 0.0 +2768 3.45 3.25 56.25 0.0336511 0.376814 -0.0335823 -0.381553 -0.376846 0.381531 0.0 +2769 3.45 3.25 63.75 0.0610398 0.568743 -0.0610638 -0.568847 -0.568734 0.568857 0.0 +2770 3.45 3.25 71.25 0.191319 0.669351 -0.191358 -0.479143 -0.669399 0.479151 0.0 +2771 3.45 3.25 78.75 0.405751 0.51543 -0.405724 -0.34219 -0.515447 0.3422 0.0 +2772 3.45 3.25 86.25 0.526203 0.236753 -0.526194 -0.259964 -0.236729 0.259964 0.0 +2773 3.45 3.25 93.75 0.497209 0.0446808 -0.49719 -0.226352 -0.0447335 0.226358 0.0 +2774 3.45 3.25 101.25 0.400656 0.0545232 -0.400668 -0.204302 -0.0545018 0.204314 0.0 +2775 3.45 3.25 108.75 0.294574 0.196188 -0.294587 -0.171634 -0.196092 0.1716 0.0 +2776 3.45 3.25 116.25 0.19472 0.324411 -0.194713 -0.123137 -0.324523 0.123175 0.0 +2777 3.45 3.25 123.75 0.132272 0.361164 -0.132303 -0.0670742 -0.361206 0.0670926 0.0 +2778 3.45 3.25 131.25 0.135206 0.313195 -0.135187 -0.0147294 -0.313223 0.0147091 0.0 +2779 3.45 3.25 138.75 0.182857 0.21121 -0.182794 0.0326203 -0.211273 -0.0325507 0.0 +2780 3.45 3.25 146.25 0.217909 0.068651 -0.217902 0.0824645 -0.0686142 -0.0825051 0.0 +2781 3.45 3.25 153.75 0.198459 -0.108935 -0.198506 0.139161 0.1089 -0.139151 0.0 +2782 3.45 3.25 161.25 0.12767 -0.302368 -0.127653 0.197311 0.302337 -0.197299 0.0 +2783 3.45 3.25 168.75 0.0427846 -0.472116 -0.0427358 0.245295 0.472357 -0.245467 0.0 +2784 3.45 3.25 176.25 -0.0129573 -0.572229 0.0129579 0.272254 0.572361 -0.272348 0.0 +2785 3.45 3.35 3.75 108.302 421.496 -108.302 5958.83 -421.496 -5958.83 0.0 +2786 3.45 3.35 11.25 41.2462 175.982 -41.2462 1273.31 -175.982 -1273.31 0.0 +2787 3.45 3.35 18.75 3.01038 41.906 -3.0104 305.247 -41.906 -305.247 0.0 +2788 3.45 3.35 26.25 -6.1326 1.47736 6.13263 54.6726 -1.47737 -54.6726 0.0 +2789 3.45 3.35 33.75 -3.31533 -1.47586 3.31531 6.12001 1.47584 -6.12 0.0 +2790 3.45 3.35 41.25 -0.645403 0.0817823 0.645396 0.522618 -0.081765 -0.52267 0.0 +2791 3.45 3.35 48.75 -0.0508309 0.0548983 0.0508385 0.088753 -0.054907 -0.0887145 0.0 +2792 3.45 3.35 56.25 -0.086444 -0.0749055 0.0864092 -0.0334013 0.0748983 0.0334289 0.0 +2793 3.45 3.35 63.75 -0.118584 0.00885222 0.118561 -0.0912918 -0.00885908 0.0913019 0.0 +2794 3.45 3.35 71.25 -0.0737239 0.0593776 0.0737854 -0.088756 -0.0594375 0.0887584 0.0 +2795 3.45 3.35 78.75 0.036563 0.0346896 -0.0365392 -0.0646539 -0.0346542 0.0646679 0.0 +2796 3.45 3.35 86.25 0.115213 -0.0407592 -0.115217 -0.0589973 0.0407232 0.0589937 0.0 +2797 3.45 3.35 93.75 0.121241 -0.0943378 -0.121253 -0.0623952 0.0942932 0.0623931 0.0 +2798 3.45 3.35 101.25 0.105666 -0.0629274 -0.105684 -0.0638035 0.0629433 0.0637916 0.0 +2799 3.45 3.35 108.75 0.100399 0.0188446 -0.100413 -0.0630221 -0.0188428 0.0629937 0.0 +2800 3.45 3.35 116.25 0.101209 0.0751847 -0.101172 -0.0564777 -0.0751112 0.0564679 0.0 +2801 3.45 3.35 123.75 0.114923 0.0786105 -0.114898 -0.0437503 -0.0785564 0.0437357 0.0 +2802 3.45 3.35 131.25 0.152279 0.0502791 -0.152333 -0.0294588 -0.050311 0.0294693 0.0 +2803 3.45 3.35 138.75 0.197497 0.0112211 -0.197509 -0.0146718 -0.0112948 0.0147128 0.0 +2804 3.45 3.35 146.25 0.218165 -0.0385802 -0.2182 0.00342743 0.0385741 -0.00344245 0.0 +2805 3.45 3.35 153.75 0.198221 -0.105349 -0.198196 0.0247121 0.105367 -0.024701 0.0 +2806 3.45 3.35 161.25 0.149784 -0.1847 -0.149761 0.0445218 0.184701 -0.0445184 0.0 +2807 3.45 3.35 168.75 0.0992213 -0.258039 -0.0992126 0.0582518 0.258116 -0.0583085 0.0 +2808 3.45 3.35 176.25 0.06856 -0.302331 -0.0685837 0.0647053 0.302274 -0.0646862 0.0 +2809 3.45 3.45 3.75 249.963 447.743 -249.963 3664.97 -447.743 -3664.97 0.0 +2810 3.45 3.45 11.25 130.312 207.993 -130.312 676.249 -207.993 -676.249 0.0 +2811 3.45 3.45 18.75 45.7667 65.0303 -45.7667 147.519 -65.0303 -147.519 0.0 +2812 3.45 3.45 26.25 8.62768 11.3441 -8.62769 23.4633 -11.3441 -23.4633 0.0 +2813 3.45 3.45 33.75 0.110016 0.590793 -0.109988 2.30758 -0.590787 -2.3076 0.0 +2814 3.45 3.45 41.25 -0.153757 -0.0039627 0.153717 0.133259 0.00394772 -0.133226 0.0 +2815 3.45 3.45 48.75 -0.0153495 -0.0393026 0.0153515 0.00700061 0.0393356 -0.00698054 0.0 +2816 3.45 3.45 56.25 -0.0482726 -0.073912 0.0483149 0.0251197 0.0739223 -0.0251188 0.0 +2817 3.45 3.45 63.75 -0.0289355 -0.0533479 0.0289021 0.00597862 0.053373 -0.00597884 0.0 +2818 3.45 3.45 71.25 -0.0187811 -0.0391984 0.018746 0.000512192 0.039198 -0.000501842 0.0 +2819 3.45 3.45 78.75 -0.00856621 -0.0176478 0.00859924 0.00690296 0.0177056 -0.00690308 0.0 +2820 3.45 3.45 86.25 0.00371125 -0.0135792 -0.00372377 0.00136037 0.0136089 -0.0013601 0.0 +2821 3.45 3.45 93.75 0.00477561 -0.0238325 -0.00478562 -0.00283706 0.0238591 0.00283968 0.0 +2822 3.45 3.45 101.25 0.00818656 -0.0174538 -0.00812902 -0.00263731 0.017444 0.00264151 0.0 +2823 3.45 3.45 108.75 0.0169419 0.00155597 -0.0169639 -0.00543721 -0.00155808 0.00543126 0.0 +2824 3.45 3.45 116.25 0.0195788 0.0116859 -0.0195369 -0.00999959 -0.0117365 0.0100136 0.0 +2825 3.45 3.45 123.75 0.0183927 0.0116238 -0.0183971 -0.013227 -0.011666 0.0132448 0.0 +2826 3.45 3.45 131.25 0.0233808 0.0121941 -0.0234038 -0.0149326 -0.0122148 0.0149266 0.0 +2827 3.45 3.45 138.75 0.0316355 0.0161105 -0.0316222 -0.0142598 -0.0161126 0.0142499 0.0 +2828 3.45 3.45 146.25 0.0319972 0.0182352 -0.0319926 -0.0107349 -0.018201 0.0107262 0.0 +2829 3.45 3.45 153.75 0.0212885 0.0151617 -0.0213003 -0.0072284 -0.0151286 0.00721379 0.0 +2830 3.45 3.45 161.25 0.00710262 0.00875975 -0.00709702 -0.00763624 -0.00879653 0.00766868 0.0 +2831 3.45 3.45 168.75 -0.0026401 0.00265877 0.00265377 -0.0121265 -0.00270055 0.0121613 0.0 +2832 3.45 3.45 176.25 -0.00643116 -0.000726218 0.00644015 -0.0165154 0.000842039 0.0164549 0.0 +2833 3.45 3.55 3.75 176.165 231.846 -176.165 1002.13 -231.846 -1002.13 0.0 +2834 3.45 3.55 11.25 95.7124 114.358 -95.7124 175.442 -114.358 -175.442 0.0 +2835 3.45 3.55 18.75 35.3486 38.8706 -35.3486 30.2113 -38.8706 -30.2113 0.0 +2836 3.45 3.55 26.25 7.45817 8.24142 -7.45818 2.93187 -8.24142 -2.93187 0.0 +2837 3.45 3.55 33.75 0.442038 0.937077 -0.442023 0.16053 -0.937083 -0.160524 0.0 +2838 3.45 3.55 41.25 -0.036135 0.0544695 0.0361478 0.0475514 -0.0544678 -0.0475693 0.0 +2839 3.45 3.55 48.75 0.0114763 -0.0262494 -0.0114589 0.0137087 0.0262505 -0.0137065 0.0 +2840 3.45 3.55 56.25 -0.0247279 -0.0151853 0.0247269 0.0138833 0.0151975 -0.0138936 0.0 +2841 3.45 3.55 63.75 -0.00534614 0.000359977 0.00535626 -0.000883675 -0.000355567 0.000884282 0.0 +2842 3.45 3.55 71.25 0.0021508 -0.00431124 -0.00217205 -0.00167595 0.00430117 0.00167024 0.0 +2843 3.45 3.55 78.75 -0.00618242 -0.0011063 0.00617677 0.00219776 0.00111944 -0.00219769 0.0 +2844 3.45 3.55 86.25 -0.00864154 0.00382556 0.00863024 -0.000880014 -0.00382877 0.000881011 0.0 +2845 3.45 3.55 93.75 -0.00688417 0.00308196 0.00688064 -0.000591138 -0.00307945 0.000591269 0.0 +2846 3.45 3.55 101.25 -0.00277733 0.00250811 0.00278446 0.00339576 -0.00248041 -0.00339897 0.0 +2847 3.45 3.55 108.75 9.6645e-05 0.00292517 -9.27955e-05 0.00533124 -0.00297869 -0.00532125 0.0 +2848 3.45 3.55 116.25 -0.00279109 0.00312423 0.0027777 0.004826 -0.00313043 -0.00482587 0.0 +2849 3.45 3.55 123.75 -0.007852 0.00420337 0.00785189 0.00337755 -0.00423422 -0.00336561 0.0 +2850 3.45 3.55 131.25 -0.00899665 0.00525366 0.00898163 0.00211415 -0.00526556 -0.00211688 0.0 +2851 3.45 3.55 138.75 -0.00658818 0.00353401 0.00658935 0.00247574 -0.00351467 -0.00247806 0.0 +2852 3.45 3.55 146.25 -0.00472251 -0.000274464 0.0047137 0.00454554 0.000265355 -0.00453667 0.0 +2853 3.45 3.55 153.75 -0.00408631 -0.00145214 0.00408205 0.00601461 0.00145164 -0.0060113 0.0 +2854 3.45 3.55 161.25 -0.00213812 0.00336809 0.00214451 0.0045329 -0.00336917 -0.00453833 0.0 +2855 3.45 3.55 168.75 0.002039 0.0122448 -0.00204369 0.000537346 -0.0122471 -0.000536574 0.0 +2856 3.45 3.55 176.25 0.00576826 0.0191805 -0.00579318 -0.00289312 -0.0192316 0.00291892 0.0 +2857 3.45 3.65 3.75 27.0106 27.9613 -27.0106 49.4083 -27.9613 -49.4083 0.0 +2858 3.45 3.65 11.25 14.9394 14.3629 -14.9394 5.91574 -14.3629 -5.91574 0.0 +2859 3.45 3.65 18.75 5.42704 4.99328 -5.42704 -0.785154 -4.99328 0.785155 0.0 +2860 3.45 3.65 26.25 1.05899 1.10476 -1.05899 -0.658621 -1.10476 0.658622 0.0 +2861 3.45 3.65 33.75 0.0281818 0.145917 -0.0281832 -0.129014 -0.145916 0.129014 0.0 +2862 3.45 3.65 41.25 -0.00445013 0.00847625 0.00444947 -0.00108348 -0.0084749 0.00108322 0.0 +2863 3.45 3.65 48.75 0.00425589 -0.0101956 -0.00425551 0.00738506 0.0101965 -0.00738428 0.0 +2864 3.45 3.65 56.25 -0.00818272 -0.00590468 0.00818308 0.00485965 0.00590354 -0.00486006 0.0 +2865 3.45 3.65 63.75 -0.00416452 -0.000816284 0.00416288 0.00103036 0.000813653 -0.00103209 0.0 +2866 3.45 3.65 71.25 0.00103127 -0.00146141 -0.00103277 0.000818187 0.00146199 -0.000819189 0.0 +2867 3.45 3.65 78.75 0.0016058 -0.00187691 -0.00160474 0.000733485 0.00187607 -0.000733211 0.0 +2868 3.45 3.65 86.25 0.00109362 -0.000919641 -0.00109306 -0.000877938 0.000920276 0.000877779 0.0 +2869 3.45 3.65 93.75 0.000615382 -0.000162543 -0.000614614 -0.00196718 0.000162038 0.00196727 0.0 +2870 3.45 3.65 101.25 0.000257077 -9.90887e-05 -0.000257803 -0.00198713 9.8806e-05 0.00198727 0.0 +2871 3.45 3.65 108.75 -0.000415666 -0.000551723 0.000416382 -0.00133258 0.000550085 0.00133277 0.0 +2872 3.45 3.65 116.25 -0.00171058 -0.00100344 0.00171033 -0.000283121 0.00100575 0.000281567 0.0 +2873 3.45 3.65 123.75 -0.00282345 -0.00136999 0.00282231 0.000681739 0.00136679 -0.000680174 0.0 +2874 3.45 3.65 131.25 -0.00293906 -0.00227991 0.00293814 0.00125143 0.00227664 -0.00125029 0.0 +2875 3.45 3.65 138.75 -0.00235433 -0.00392254 0.0023561 0.0016008 0.00392512 -0.00160107 0.0 +2876 3.45 3.65 146.25 -0.00181787 -0.00523799 0.00181858 0.00193355 0.00523773 -0.00193291 0.0 +2877 3.45 3.65 153.75 -0.00147655 -0.00473654 0.00147561 0.00211445 0.00473647 -0.00211477 0.0 +2878 3.45 3.65 161.25 -0.000967812 -0.00201348 0.000967111 0.00191586 0.00201087 -0.00191381 0.0 +2879 3.45 3.65 168.75 -0.000185572 0.00169462 0.000184459 0.00140918 -0.00169418 -0.00140983 0.0 +2880 3.45 3.65 176.25 0.000452234 0.00431542 -0.000452919 0.000978651 -0.00431348 -0.000979895 0.0 +2881 3.55 2.55 3.75 -229.406 -210.878 229.406 294.295 210.878 -294.295 0.0 +2882 3.55 2.55 11.25 -199.57 -142.531 199.57 214.774 142.531 -214.774 0.0 +2883 3.55 2.55 18.75 -155.766 -47.9091 155.766 136.693 47.9091 -136.693 0.0 +2884 3.55 2.55 26.25 -113.195 30.0688 113.195 89.2497 -30.0688 -89.2497 0.0 +2885 3.55 2.55 33.75 -77.4432 72.6073 77.4432 57.649 -72.6073 -57.649 0.0 +2886 3.55 2.55 41.25 -47.4313 83.435 47.4313 29.1262 -83.435 -29.1262 0.0 +2887 3.55 2.55 48.75 -21.4656 76.4023 21.4655 3.49717 -76.4023 -3.49717 0.0 +2888 3.55 2.55 56.25 0.0313289 64.405 -0.0313427 -14.8015 -64.405 14.8015 0.0 +2889 3.55 2.55 63.75 15.3842 54.1613 -15.3842 -23.4846 -54.1613 23.4846 0.0 +2890 3.55 2.55 71.25 23.5807 46.4646 -23.5807 -23.8098 -46.4646 23.8098 0.0 +2891 3.55 2.55 78.75 25.4225 39.3366 -25.4225 -19.2609 -39.3366 19.2609 0.0 +2892 3.55 2.55 86.25 23.3388 31.024 -23.3388 -13.5921 -31.0241 13.5921 0.0 +2893 3.55 2.55 93.75 20.1539 21.135 -20.1539 -9.24297 -21.135 9.24297 0.0 +2894 3.55 2.55 101.25 17.7701 10.268 -17.7701 -6.83623 -10.268 6.83623 0.0 +2895 3.55 2.55 108.75 16.6831 -0.675633 -16.6831 -5.75168 0.675638 5.75168 0.0 +2896 3.55 2.55 116.25 16.4196 -10.8522 -16.4196 -5.06569 10.8522 5.06568 0.0 +2897 3.55 2.55 123.75 16.2857 -19.5797 -16.2857 -4.17308 19.5797 4.17308 0.0 +2898 3.55 2.55 131.25 15.8485 -26.4045 -15.8485 -2.91647 26.4045 2.91647 0.0 +2899 3.55 2.55 138.75 15.02 -31.1759 -15.02 -1.42561 31.1759 1.4256 0.0 +2900 3.55 2.55 146.25 13.9278 -34.062 -13.9278 0.0838222 34.0619 -0.0838168 0.0 +2901 3.55 2.55 153.75 12.7687 -35.4729 -12.7687 1.42997 35.4729 -1.42997 0.0 +2902 3.55 2.55 161.25 11.7278 -35.927 -11.7278 2.49848 35.927 -2.49848 0.0 +2903 3.55 2.55 168.75 10.9505 -35.9169 -10.9505 3.23067 35.917 -3.23067 0.0 +2904 3.55 2.55 176.25 10.5363 -35.8139 -10.5363 3.60114 35.8139 -3.60114 0.0 +2905 3.55 2.65 3.75 -251.703 -244.274 251.703 410.77 244.274 -410.77 0.0 +2906 3.55 2.65 11.25 -212.889 -171.396 212.889 279.716 171.396 -279.716 0.0 +2907 3.55 2.65 18.75 -157.426 -73.7037 157.426 160.214 73.7037 -160.214 0.0 +2908 3.55 2.65 26.25 -106.127 3.62033 106.127 94.6298 -3.62033 -94.6298 0.0 +2909 3.55 2.65 33.75 -66.6414 43.9955 66.6414 57.7405 -43.9955 -57.7405 0.0 +2910 3.55 2.65 41.25 -37.1568 54.118 37.1568 29.0601 -54.118 -29.0601 0.0 +2911 3.55 2.65 48.75 -14.1506 48.9325 14.1506 5.36658 -48.9325 -5.36657 0.0 +2912 3.55 2.65 56.25 3.71459 40.5629 -3.71458 -10.365 -40.5629 10.365 0.0 +2913 3.55 2.65 63.75 16.0185 34.4708 -16.0185 -17.0997 -34.4708 17.0997 0.0 +2914 3.55 2.65 71.25 22.3492 30.686 -22.3492 -16.8785 -30.686 16.8785 0.0 +2915 3.55 2.65 78.75 23.4632 27.0893 -23.4632 -13.1658 -27.0893 13.1658 0.0 +2916 3.55 2.65 86.25 21.3128 22.1249 -21.3128 -9.07321 -22.1249 9.07321 0.0 +2917 3.55 2.65 93.75 18.1341 15.6344 -18.1341 -6.27069 -15.6344 6.2707 0.0 +2918 3.55 2.65 101.25 15.3987 8.31199 -15.3987 -4.90709 -8.31198 4.90709 0.0 +2919 3.55 2.65 108.75 13.4619 0.987899 -13.4619 -4.30622 -0.987895 4.30622 0.0 +2920 3.55 2.65 116.25 11.9812 -5.67249 -11.9811 -3.75874 5.67248 3.75874 0.0 +2921 3.55 2.65 123.75 10.533 -11.1925 -10.533 -2.9196 11.1925 2.9196 0.0 +2922 3.55 2.65 131.25 8.93728 -15.2892 -8.93728 -1.7942 15.2892 1.7942 0.0 +2923 3.55 2.65 138.75 7.2458 -17.9112 -7.24581 -0.551666 17.9112 0.551669 0.0 +2924 3.55 2.65 146.25 5.60299 -19.2413 -5.60297 0.632986 19.2413 -0.632993 0.0 +2925 3.55 2.65 153.75 4.14439 -19.6283 -4.1444 1.64399 19.6283 -1.64399 0.0 +2926 3.55 2.65 161.25 2.96848 -19.4785 -2.96847 2.42373 19.4785 -2.42373 0.0 +2927 3.55 2.65 168.75 2.14406 -19.1576 -2.14405 2.94939 19.1576 -2.94938 0.0 +2928 3.55 2.65 176.25 1.71892 -18.9295 -1.71891 3.21334 18.9295 -3.21334 0.0 +2929 3.55 2.75 3.75 -264.315 -251.884 264.315 554.153 251.884 -554.153 0.0 +2930 3.55 2.75 11.25 -218.018 -178.063 218.018 348.569 178.063 -348.569 0.0 +2931 3.55 2.75 18.75 -153.431 -82.237 153.431 177.523 82.237 -177.523 0.0 +2932 3.55 2.75 26.25 -95.9973 -9.58238 95.9973 92.8913 9.58238 -92.8913 0.0 +2933 3.55 2.75 33.75 -54.8909 26.1439 54.8909 52.4496 -26.1439 -52.4496 0.0 +2934 3.55 2.75 41.25 -27.4701 34.2513 27.4701 25.5556 -34.2513 -25.5556 0.0 +2935 3.55 2.75 48.75 -8.47775 30.1327 8.47774 5.12254 -30.1327 -5.12254 0.0 +2936 3.55 2.75 56.25 5.07875 24.538 -5.07874 -7.50333 -24.538 7.50333 0.0 +2937 3.55 2.75 63.75 13.9817 21.3671 -13.9817 -12.2962 -21.3671 12.2962 0.0 +2938 3.55 2.75 71.25 18.3904 19.9549 -18.3905 -11.6735 -19.9549 11.6735 0.0 +2939 3.55 2.75 78.75 18.9591 18.3138 -18.959 -8.76449 -18.3138 8.76449 0.0 +2940 3.55 2.75 86.25 17.0821 15.3211 -17.0821 -5.94741 -15.3211 5.94741 0.0 +2941 3.55 2.75 93.75 14.3506 11.1288 -14.3506 -4.23127 -11.1288 4.23127 0.0 +2942 3.55 2.75 101.25 11.7989 6.47419 -11.7989 -3.47648 -6.47418 3.47648 0.0 +2943 3.55 2.75 108.75 9.66457 2.01951 -9.66458 -3.0836 -2.0195 3.0836 0.0 +2944 3.55 2.75 116.25 7.74129 -1.82686 -7.7413 -2.58215 1.82685 2.58216 0.0 +2945 3.55 2.75 123.75 5.83466 -4.83284 -5.83465 -1.82939 4.83283 1.8294 0.0 +2946 3.55 2.75 131.25 3.93964 -6.88932 -3.93963 -0.91277 6.8893 0.912773 0.0 +2947 3.55 2.75 138.75 2.16628 -8.02362 -2.16626 0.0181776 8.02364 -0.0181816 0.0 +2948 3.55 2.75 146.25 0.619367 -8.40184 -0.619378 0.852629 8.40183 -0.852624 0.0 +2949 3.55 2.75 153.75 -0.648178 -8.27967 0.648181 1.53734 8.27967 -1.53733 0.0 +2950 3.55 2.75 161.25 -1.61826 -7.92733 1.61826 2.0554 7.92733 -2.0554 0.0 +2951 3.55 2.75 168.75 -2.27916 -7.56871 2.27916 2.4029 7.56872 -2.4029 0.0 +2952 3.55 2.75 176.25 -2.61565 -7.3533 2.61565 2.5776 7.35327 -2.57759 0.0 +2953 3.55 2.85 3.75 -261.527 -235.81 261.527 724.836 235.81 -724.836 0.0 +2954 3.55 2.85 11.25 -211.244 -166.597 211.244 416.164 166.597 -416.164 0.0 +2955 3.55 2.85 18.75 -142.48 -78.6912 142.48 186.852 78.6912 -186.852 0.0 +2956 3.55 2.85 26.25 -83.1221 -14.2229 83.1221 84.8442 14.223 -84.8442 0.0 +2957 3.55 2.85 33.75 -43.0885 15.5567 43.0885 43.3483 -15.5567 -43.3483 0.0 +2958 3.55 2.85 41.25 -19.0807 21.2967 19.0807 20.0983 -21.2967 -20.0983 0.0 +2959 3.55 2.85 48.75 -4.56564 17.9239 4.56566 3.89029 -17.9239 -3.89029 0.0 +2960 3.55 2.85 56.25 4.68974 14.4266 -4.68973 -5.45881 -14.4266 5.45881 0.0 +2961 3.55 2.85 63.75 10.3993 13.1365 -10.3993 -8.55525 -13.1365 8.55525 0.0 +2962 3.55 2.85 71.25 13.149 12.9016 -13.149 -7.76157 -12.9016 7.76157 0.0 +2963 3.55 2.85 78.75 13.4264 12.095 -13.4264 -5.62748 -12.095 5.62748 0.0 +2964 3.55 2.85 86.25 12.0608 10.1297 -12.0608 -3.80584 -10.1297 3.80584 0.0 +2965 3.55 2.85 93.75 10.0367 7.43249 -10.0367 -2.80863 -7.4325 2.80863 0.0 +2966 3.55 2.85 101.25 8.01353 4.69251 -8.01354 -2.3777 -4.69252 2.3777 0.0 +2967 3.55 2.85 108.75 6.15338 2.33759 -6.15338 -2.06536 -2.33757 2.06536 0.0 +2968 3.55 2.85 116.25 4.37451 0.505156 -4.37452 -1.6121 -0.505158 1.61211 0.0 +2969 3.55 2.85 123.75 2.64685 -0.790656 -2.64685 -1.0014 0.790603 1.00141 0.0 +2970 3.55 2.85 131.25 1.0548 -1.57001 -1.05481 -0.336579 1.57001 0.336585 0.0 +2971 3.55 2.85 138.75 -0.301249 -1.89549 0.301247 0.282316 1.8955 -0.282321 0.0 +2972 3.55 2.85 146.25 -1.3849 -1.88523 1.38489 0.806188 1.88523 -0.806188 0.0 +2973 3.55 2.85 153.75 -2.21895 -1.68823 2.21895 1.22569 1.68826 -1.2257 0.0 +2974 3.55 2.85 161.25 -2.83872 -1.44066 2.83873 1.54425 1.44064 -1.54424 0.0 +2975 3.55 2.85 168.75 -3.25933 -1.23657 3.25933 1.76182 1.23656 -1.76182 0.0 +2976 3.55 2.85 176.25 -3.47478 -1.12538 3.47479 1.87313 1.12538 -1.87313 0.0 +2977 3.55 2.95 3.75 -238.248 -195.778 238.248 919.354 195.778 -919.354 0.0 +2978 3.55 2.95 11.25 -189.674 -139.46 189.674 474.265 139.46 -474.265 0.0 +2979 3.55 2.95 18.75 -123.906 -67.0584 123.906 186.836 67.0584 -186.836 0.0 +2980 3.55 2.95 26.25 -68.0315 -14.1389 68.0315 72.1684 14.1389 -72.1684 0.0 +2981 3.55 2.95 33.75 -31.9787 9.22621 31.9787 32.4164 -9.22622 -32.4164 0.0 +2982 3.55 2.95 41.25 -12.3582 12.9007 12.3583 14.1095 -12.9007 -14.1095 0.0 +2983 3.55 2.95 48.75 -2.18494 10.2138 2.18496 2.49295 -10.2139 -2.49296 0.0 +2984 3.55 2.95 56.25 3.3582 8.24208 -3.35821 -3.79474 -8.24206 3.79474 0.0 +2985 3.55 2.95 63.75 6.49294 8.02143 -6.49294 -5.58908 -8.02143 5.58908 0.0 +2986 3.55 2.95 71.25 8.02049 8.19907 -8.0205 -4.84949 -8.19905 4.84949 0.0 +2987 3.55 2.95 78.75 8.22344 7.62696 -8.22344 -3.42621 -7.62696 3.42621 0.0 +2988 3.55 2.95 86.25 7.44006 6.19885 -7.44002 -2.34519 -6.19886 2.34519 0.0 +2989 3.55 2.95 93.75 6.16909 4.49074 -6.16911 -1.80008 -4.49073 1.80008 0.0 +2990 3.55 2.95 101.25 4.7983 3.05613 -4.79831 -1.53727 -3.05611 1.53727 0.0 +2991 3.55 2.95 108.75 3.45573 2.08096 -3.45575 -1.27583 -2.08101 1.27584 0.0 +2992 3.55 2.95 116.25 2.15328 1.48623 -2.15328 -0.907415 -1.48624 0.907424 0.0 +2993 3.55 2.95 123.75 0.949834 1.14548 -0.949837 -0.471692 -1.14549 0.471698 0.0 +2994 3.55 2.95 131.25 -0.0550126 0.978085 0.0550168 -0.0490852 -0.978089 0.0490994 0.0 +2995 3.55 2.95 138.75 -0.810377 0.930404 0.810378 0.312048 -0.930407 -0.312044 0.0 +2996 3.55 2.95 146.25 -1.34711 0.946474 1.34711 0.605449 -0.946508 -0.605443 0.0 +2997 3.55 2.95 153.75 -1.73568 0.972292 1.73566 0.843093 -0.972294 -0.843115 0.0 +2998 3.55 2.95 161.25 -2.0293 0.976791 2.0293 1.03229 -0.976772 -1.0323 0.0 +2999 3.55 2.95 168.75 -2.2408 0.960264 2.24081 1.16853 -0.960251 -1.16853 0.0 +3000 3.55 2.95 176.25 -2.35501 0.942937 2.355 1.24087 -0.942925 -1.24088 0.0 +3001 3.55 3.05 3.75 -191.297 -130.082 191.297 1128.5 130.082 -1128.5 0.0 +3002 3.55 3.05 11.25 -152.226 -97.7637 152.226 511.643 97.7637 -511.643 0.0 +3003 3.55 3.05 18.75 -98.1201 -49.6499 98.1201 176.712 49.6499 -176.712 0.0 +3004 3.55 3.05 26.25 -51.5683 -11.65 51.5683 57.077 11.65 -57.077 0.0 +3005 3.55 3.05 33.75 -22.1446 5.20584 22.1446 21.6579 -5.20585 -21.6579 0.0 +3006 3.55 3.05 41.25 -7.38019 7.37579 7.38014 8.71709 -7.37577 -8.71708 0.0 +3007 3.55 3.05 48.75 -0.926333 5.37849 0.926342 1.38286 -5.3785 -1.38286 0.0 +3008 3.55 3.05 56.25 1.85514 4.42058 -1.85514 -2.37141 -4.42058 2.3714 0.0 +3009 3.55 3.05 63.75 3.22617 4.68783 -3.22619 -3.29462 -4.68786 3.29461 0.0 +3010 3.55 3.05 71.25 3.99011 4.90415 -3.99008 -2.75614 -4.9041 2.75615 0.0 +3011 3.55 3.05 78.75 4.23211 4.38385 -4.2321 -1.92599 -4.38384 1.92599 0.0 +3012 3.55 3.05 86.25 3.94062 3.32631 -3.9406 -1.36028 -3.3263 1.36028 0.0 +3013 3.55 3.05 93.75 3.29323 2.3031 -3.29324 -1.08948 -2.30313 1.08948 0.0 +3014 3.55 3.05 101.25 2.51472 1.68908 -2.51471 -0.92722 -1.68906 0.92722 0.0 +3015 3.55 3.05 108.75 1.72258 1.48366 -1.72257 -0.729229 -1.48363 0.72922 0.0 +3016 3.55 3.05 116.25 0.978063 1.49003 -0.978058 -0.472368 -1.49006 0.47237 0.0 +3017 3.55 3.05 123.75 0.361941 1.5347 -0.361928 -0.204692 -1.53463 0.204681 0.0 +3018 3.55 3.05 131.25 -0.0580488 1.53872 0.0580497 0.0271852 -1.53873 -0.02718 0.0 +3019 3.55 3.05 138.75 -0.288182 1.48156 0.28818 0.211303 -1.48158 -0.211288 0.0 +3020 3.55 3.05 146.25 -0.402687 1.35988 0.402687 0.361419 -1.35985 -0.361436 0.0 +3021 3.55 3.05 153.75 -0.484044 1.18137 0.484038 0.493182 -1.18138 -0.493177 0.0 +3022 3.55 3.05 161.25 -0.573201 0.974726 0.573209 0.609288 -0.974728 -0.60928 0.0 +3023 3.55 3.05 168.75 -0.662445 0.789454 0.662456 0.699577 -0.789456 -0.699573 0.0 +3024 3.55 3.05 176.25 -0.7198 0.679375 0.719786 0.749601 -0.679392 -0.749593 0.0 +3025 3.55 3.15 3.75 -120.535 -38.5135 120.535 1334.4 38.5135 -1334.4 0.0 +3026 3.55 3.15 11.25 -100.361 -42.9397 100.361 515.461 42.9397 -515.461 0.0 +3027 3.55 3.15 18.75 -66.8257 -27.6715 66.8257 156.437 27.6715 -156.437 0.0 +3028 3.55 3.15 26.25 -34.8806 -7.69081 34.8806 41.7654 7.69081 -41.7654 0.0 +3029 3.55 3.15 33.75 -13.9952 2.60989 13.9952 12.6685 -2.60989 -12.6685 0.0 +3030 3.55 3.15 41.25 -4.0045 3.76721 4.00452 4.60296 -3.76722 -4.60296 0.0 +3031 3.55 3.15 48.75 -0.362908 2.40871 0.362911 0.684517 -2.40873 -0.684496 0.0 +3032 3.55 3.15 56.25 0.698355 2.02222 -0.698341 -1.23238 -2.0222 1.23238 0.0 +3033 3.55 3.15 63.75 1.08795 2.40699 -1.08797 -1.65461 -2.40696 1.65462 0.0 +3034 3.55 3.15 71.25 1.45251 2.55615 -1.45253 -1.35584 -2.55613 1.35584 0.0 +3035 3.55 3.15 78.75 1.73638 2.12607 -1.73637 -0.957408 -2.12608 0.957409 0.0 +3036 3.55 3.15 86.25 1.74868 1.41086 -1.74869 -0.717153 -1.41085 0.717153 0.0 +3037 3.55 3.15 93.75 1.5066 0.86199 -1.5066 -0.608615 -0.862043 0.608616 0.0 +3038 3.55 3.15 101.25 1.15427 0.692349 -1.15426 -0.521959 -0.692347 0.521961 0.0 +3039 3.55 3.15 108.75 0.799794 0.807097 -0.799796 -0.399775 -0.80711 0.399772 0.0 +3040 3.55 3.15 116.25 0.510123 0.993297 -0.510111 -0.252463 -0.993286 0.252463 0.0 +3041 3.55 3.15 123.75 0.344561 1.10258 -0.344571 -0.114896 -1.10259 0.114902 0.0 +3042 3.55 3.15 131.25 0.32494 1.09044 -0.324933 -0.00704299 -1.09044 0.00704928 0.0 +3043 3.55 3.15 138.75 0.404925 0.966593 -0.404949 0.0762265 -0.966647 -0.0762275 0.0 +3044 3.55 3.15 146.25 0.499444 0.753676 -0.499415 0.151485 -0.753669 -0.151477 0.0 +3045 3.55 3.15 153.75 0.542832 0.481048 -0.542816 0.22901 -0.481047 -0.229008 0.0 +3046 3.55 3.15 161.25 0.522198 0.193975 -0.522177 0.305586 -0.193965 -0.305594 0.0 +3047 3.55 3.15 168.75 0.468573 -0.0480481 -0.468564 0.368598 0.048046 -0.368601 0.0 +3048 3.55 3.15 176.25 0.426757 -0.187013 -0.426752 0.404298 0.186996 -0.404293 0.0 +3049 3.55 3.25 3.75 -29.6653 73.925 29.6653 1503.64 -73.925 -1503.64 0.0 +3050 3.55 3.25 11.25 -38.343 21.1792 38.343 474.484 -21.1792 -474.484 0.0 +3051 3.55 3.25 18.75 -32.9234 -2.3694 32.9234 126.727 2.3694 -126.727 0.0 +3052 3.55 3.25 26.25 -19.3004 -2.48733 19.3004 27.8286 2.48732 -27.8286 0.0 +3053 3.55 3.25 33.75 -7.74679 1.20452 7.74681 6.29538 -1.20452 -6.29539 0.0 +3054 3.55 3.25 41.25 -1.94619 1.60378 1.94618 1.96617 -1.60377 -1.96616 0.0 +3055 3.55 3.25 48.75 -0.157335 0.755813 0.157348 0.31596 -0.755837 -0.315945 0.0 +3056 3.55 3.25 56.25 0.0714287 0.611962 -0.0714357 -0.460837 -0.611969 0.460849 0.0 +3057 3.55 3.25 63.75 0.0702285 0.923583 -0.0701829 -0.637809 -0.923614 0.637808 0.0 +3058 3.55 3.25 71.25 0.254878 1.02447 -0.25488 -0.526913 -1.02446 0.526913 0.0 +3059 3.55 3.25 78.75 0.514287 0.758419 -0.514308 -0.387335 -0.758396 0.387332 0.0 +3060 3.55 3.25 86.25 0.632201 0.354653 -0.632241 -0.323832 -0.354649 0.323832 0.0 +3061 3.55 3.25 93.75 0.582318 0.103028 -0.582347 -0.305332 -0.103026 0.305331 0.0 +3062 3.55 3.25 101.25 0.46996 0.111698 -0.46996 -0.276841 -0.111679 0.276842 0.0 +3063 3.55 3.25 108.75 0.380585 0.279066 -0.380591 -0.223034 -0.279092 0.223042 0.0 +3064 3.55 3.25 116.25 0.358122 0.44336 -0.358142 -0.159424 -0.443412 0.159434 0.0 +3065 3.55 3.25 123.75 0.427025 0.512673 -0.427042 -0.104868 -0.51267 0.104858 0.0 +3066 3.55 3.25 131.25 0.574576 0.475402 -0.574594 -0.0645124 -0.475427 0.0645121 0.0 +3067 3.55 3.25 138.75 0.741562 0.351546 -0.741556 -0.0294911 -0.351565 0.0294968 0.0 +3068 3.55 3.25 146.25 0.857969 0.161727 -0.85796 0.0114794 -0.16175 -0.0114787 0.0 +3069 3.55 3.25 153.75 0.888764 -0.0710245 -0.888769 0.0613246 0.071072 -0.0613482 0.0 +3070 3.55 3.25 161.25 0.848268 -0.311204 -0.848278 0.113131 0.311192 -0.113144 0.0 +3071 3.55 3.25 168.75 0.781206 -0.511438 -0.781203 0.155702 0.511431 -0.155695 0.0 +3072 3.55 3.25 176.25 0.733873 -0.625736 -0.733895 0.1795 0.625763 -0.179513 0.0 +3073 3.55 3.35 3.75 70.5641 186.771 -70.5641 1508.57 -186.771 -1508.57 0.0 +3074 3.55 3.35 11.25 26.1135 83.8672 -26.1135 369.137 -83.8672 -369.137 0.0 +3075 3.55 3.35 18.75 -0.0874673 23.0482 0.0874728 85.6093 -23.0482 -85.6093 0.0 +3076 3.55 3.35 26.25 -5.90552 3.52135 5.90552 15.2641 -3.52136 -15.2641 0.0 +3077 3.55 3.35 33.75 -3.28275 0.861657 3.28277 2.42219 -0.861647 -2.42219 0.0 +3078 3.55 3.35 41.25 -0.811789 0.540902 0.811771 0.587392 -0.540899 -0.587387 0.0 +3079 3.55 3.35 48.75 -0.092098 0.0540773 0.0921139 0.12834 -0.0540653 -0.128329 0.0 +3080 3.55 3.35 56.25 -0.113419 -0.0251278 0.113414 -0.065704 0.0251121 0.0657004 0.0 +3081 3.55 3.35 63.75 -0.169707 0.151465 0.169684 -0.136214 -0.151455 0.136224 0.0 +3082 3.55 3.35 71.25 -0.0770462 0.234517 0.0770254 -0.122786 -0.234512 0.122797 0.0 +3083 3.55 3.35 78.75 0.080157 0.14264 -0.0801127 -0.0976888 -0.142618 0.0976915 0.0 +3084 3.55 3.35 86.25 0.16526 -0.0245321 -0.16523 -0.105724 0.0245585 0.105724 0.0 +3085 3.55 3.35 93.75 0.16494 -0.121904 -0.164953 -0.124366 0.121903 0.124366 0.0 +3086 3.55 3.35 101.25 0.150547 -0.0889324 -0.150553 -0.128054 0.0889257 0.128048 0.0 +3087 3.55 3.35 108.75 0.170286 0.0175738 -0.170291 -0.117975 -0.0175791 0.117976 0.0 +3088 3.55 3.35 116.25 0.23787 0.110881 -0.237884 -0.105416 -0.110839 0.105397 0.0 +3089 3.55 3.35 123.75 0.352555 0.149885 -0.352566 -0.0967577 -0.149898 0.0967502 0.0 +3090 3.55 3.35 131.25 0.489812 0.135495 -0.489818 -0.0893887 -0.135477 0.0893863 0.0 +3091 3.55 3.35 138.75 0.60086 0.077142 -0.600855 -0.0756476 -0.0771297 0.0756365 0.0 +3092 3.55 3.35 146.25 0.643546 -0.0196771 -0.643564 -0.0510493 0.0196634 0.0510486 0.0 +3093 3.55 3.35 153.75 0.611551 -0.145928 -0.611561 -0.0188268 0.145921 0.0188254 0.0 +3094 3.55 3.35 161.25 0.533916 -0.281245 -0.533921 0.0128836 0.281282 -0.0128976 0.0 +3095 3.55 3.35 168.75 0.453006 -0.396367 -0.453027 0.0367463 0.396347 -0.036746 0.0 +3096 3.55 3.35 176.25 0.403626 -0.462625 -0.403626 0.0491182 0.462593 -0.0490967 0.0 +3097 3.55 3.45 3.75 121.762 207.785 -121.762 962.688 -207.785 -962.688 0.0 +3098 3.55 3.45 11.25 60.8866 100.045 -60.8866 171.897 -100.045 -171.897 0.0 +3099 3.55 3.45 18.75 19.2588 32.9384 -19.2588 31.2407 -32.9384 -31.2407 0.0 +3100 3.55 3.45 26.25 2.44295 6.83148 -2.44294 3.77225 -6.83148 -3.77225 0.0 +3101 3.55 3.45 33.75 -0.567079 0.958398 0.567088 0.416847 -0.958393 -0.416854 0.0 +3102 3.55 3.45 41.25 -0.222537 0.179899 0.222522 0.084085 -0.179913 -0.0840813 0.0 +3103 3.55 3.45 48.75 -0.0448672 -0.0437923 0.0448399 0.028244 0.0437888 -0.0282332 0.0 +3104 3.55 3.45 56.25 -0.0627155 -0.090292 0.0626997 0.0294423 0.0902953 -0.0294398 0.0 +3105 3.55 3.45 63.75 -0.0651564 -0.0351753 0.0651434 0.00414308 0.035192 -0.00412588 0.0 +3106 3.55 3.45 71.25 -0.042218 0.0132608 0.0422006 -0.00188957 -0.0132483 0.00189618 0.0 +3107 3.55 3.45 78.75 -0.0116982 0.0190232 0.011707 1.57271e-05 -0.0190144 -1.64085e-05 0.0 +3108 3.55 3.45 86.25 0.00013451 -0.0138769 -0.000144209 -0.0123824 0.0138849 0.0123821 0.0 +3109 3.55 3.45 93.75 -0.00393746 -0.0447471 0.00392985 -0.0246058 0.0447166 0.0246083 0.0 +3110 3.55 3.45 101.25 0.00141228 -0.0409447 -0.0013985 -0.0283161 0.0409468 0.0283156 0.0 +3111 3.55 3.45 108.75 0.0263281 -0.010178 -0.0263265 -0.0311072 0.0101511 0.0311133 0.0 +3112 3.55 3.45 116.25 0.0681867 0.0249438 -0.0681732 -0.0385014 -0.0249297 0.0385108 0.0 +3113 3.55 3.45 123.75 0.121836 0.0519122 -0.121824 -0.0480196 -0.0519073 0.048018 0.0 +3114 3.55 3.45 131.25 0.172268 0.0658221 -0.17226 -0.0530535 -0.0658407 0.0530668 0.0 +3115 3.55 3.45 138.75 0.195564 0.0618726 -0.19556 -0.0485273 -0.0619059 0.0485432 0.0 +3116 3.55 3.45 146.25 0.177362 0.0378149 -0.17737 -0.0351206 -0.0378521 0.0351336 0.0 +3117 3.55 3.45 153.75 0.125251 -0.00187406 -0.125266 -0.0186947 0.00187352 0.018683 0.0 +3118 3.55 3.45 161.25 0.0620088 -0.0466966 -0.0619998 -0.0055378 0.0466948 0.00554231 0.0 +3119 3.55 3.45 168.75 0.00986362 -0.0846755 -0.00985828 0.00176039 0.0846777 -0.00175711 0.0 +3120 3.55 3.45 176.25 -0.0183927 -0.10623 0.0183719 0.00441031 0.106201 -0.00440336 0.0 +3121 3.55 3.55 3.75 81.0059 113.34 -81.0059 260.352 -113.34 -260.352 0.0 +3122 3.55 3.55 11.25 42.1524 56.4121 -42.1524 26.3617 -56.4121 -26.3617 0.0 +3123 3.55 3.55 18.75 14.7132 19.7973 -14.7132 -0.755035 -19.7973 0.755033 0.0 +3124 3.55 3.55 26.25 2.79612 4.5306 -2.79613 -1.38915 -4.53059 1.38915 0.0 +3125 3.55 3.55 33.75 0.10053 0.64794 -0.100533 -0.160016 -0.647941 0.160018 0.0 +3126 3.55 3.55 41.25 -0.0178303 0.07505 0.0178293 0.0195223 -0.0750523 -0.0195244 0.0 +3127 3.55 3.55 48.75 -0.00517875 -0.00351167 0.00518041 0.00760166 0.00350383 -0.00760536 0.0 +3128 3.55 3.55 56.25 -0.0146237 -0.0107977 0.0146179 0.0109189 0.0107984 -0.0109269 0.0 +3129 3.55 3.55 63.75 -3.87507e-05 -0.00362228 4.15324e-05 -0.000860953 0.0036153 0.000862609 0.0 +3130 3.55 3.55 71.25 0.00025554 0.00310581 -0.000258051 -0.00193062 -0.00311301 0.00192984 0.0 +3131 3.55 3.55 78.75 -0.00939829 0.0115235 0.0094016 0.000961058 -0.0115276 -0.000962838 0.0 +3132 3.55 3.55 86.25 -0.0165596 0.0133942 0.0165552 -0.000618444 -0.0133937 0.000618414 0.0 +3133 3.55 3.55 93.75 -0.0192198 0.0081303 0.0192237 0.000800086 -0.00813014 -0.000800389 0.0 +3134 3.55 3.55 101.25 -0.0173135 0.00397392 0.017316 0.00498683 -0.0039722 -0.00498686 0.0 +3135 3.55 3.55 108.75 -0.0127763 0.00613703 0.0127729 0.00547732 -0.00614031 -0.00547708 0.0 +3136 3.55 3.55 116.25 -0.00660985 0.0146966 0.00660871 0.000809944 -0.0146938 -0.000810497 0.0 +3137 3.55 3.55 123.75 0.00134833 0.025362 -0.00135008 -0.00514917 -0.0253577 0.0051477 0.0 +3138 3.55 3.55 131.25 0.00729171 0.0312649 -0.00729682 -0.00779015 -0.0312805 0.00779548 0.0 +3139 3.55 3.55 138.75 0.00442273 0.0279187 -0.00442424 -0.00517592 -0.0279147 0.00517078 0.0 +3140 3.55 3.55 146.25 -0.0095565 0.0168767 0.00955964 0.000965394 -0.0168727 -0.000968108 0.0 +3141 3.55 3.55 153.75 -0.0293138 0.00381127 0.0293123 0.00695552 -0.00382228 -0.00695117 0.0 +3142 3.55 3.55 161.25 -0.0467198 -0.00619086 0.0467172 0.0101031 0.00618452 -0.0101001 0.0 +3143 3.55 3.55 168.75 -0.0572524 -0.0115126 0.0572543 0.0103575 0.0115196 -0.0103592 0.0 +3144 3.55 3.55 176.25 -0.0614583 -0.0133864 0.0614549 0.00960442 0.0133863 -0.00960501 0.0 +3145 3.55 3.65 3.75 12.0786 14.33 -12.0786 4.38613 -14.33 -4.38613 0.0 +3146 3.55 3.65 11.25 6.33912 7.33576 -6.33912 -3.18423 -7.33576 3.18423 0.0 +3147 3.55 3.65 18.75 2.17784 2.6298 -2.17784 -1.96003 -2.6298 1.96003 0.0 +3148 3.55 3.65 26.25 0.39006 0.617253 -0.390059 -0.575786 -0.617253 0.575786 0.0 +3149 3.55 3.65 33.75 0.012681 0.0862211 -0.0126807 -0.0681723 -0.0862212 0.0681722 0.0 +3150 3.55 3.65 41.25 0.00502234 0.00223156 -0.00502212 0.00459513 -0.00223169 -0.00459442 0.0 +3151 3.55 3.65 48.75 0.00119944 -0.00628422 -0.00119894 0.00406756 0.00628446 -0.004068 0.0 +3152 3.55 3.65 56.25 -0.00386742 -0.003943 0.0038666 0.00178896 0.00394351 -0.00178918 0.0 +3153 3.55 3.65 63.75 -8.12468e-05 -0.00348925 8.0267e-05 -0.000674629 0.00348964 0.000674362 0.0 +3154 3.55 3.65 71.25 0.00192557 -0.00505585 -0.00192533 -0.00075298 0.00505521 0.00075297 0.0 +3155 3.55 3.65 78.75 0.00130323 -0.00454114 -0.0013032 -0.000636843 0.00454084 0.000636893 0.0 +3156 3.55 3.65 86.25 0.000803867 -0.00245655 -0.00080399 -0.00102105 0.0024577 0.00102106 0.0 +3157 3.55 3.65 93.75 0.0005973 -0.00111275 -0.000596389 -0.00057336 0.00111433 0.000573242 0.0 +3158 3.55 3.65 101.25 8.21929e-06 -0.00103481 -8.12152e-06 0.000450279 0.00103466 -0.00045023 0.0 +3159 3.55 3.65 108.75 -0.00119309 -0.00126494 0.00119399 0.0010993 0.00126523 -0.00109935 0.0 +3160 3.55 3.65 116.25 -0.00250233 -0.00111306 0.0025023 0.00122707 0.00111394 -0.00122737 0.0 +3161 3.55 3.65 123.75 -0.00325961 -0.00112678 0.00325939 0.00125572 0.00112681 -0.00125599 0.0 +3162 3.55 3.65 131.25 -0.0035151 -0.00233904 0.00351542 0.00158179 0.00233879 -0.00158147 0.0 +3163 3.55 3.65 138.75 -0.00380524 -0.00487295 0.00380513 0.00228977 0.0048732 -0.00229011 0.0 +3164 3.55 3.65 146.25 -0.00421555 -0.00763611 0.00421483 0.00312216 0.00763468 -0.00312155 0.0 +3165 3.55 3.65 153.75 -0.0041875 -0.00929866 0.0041879 0.00369562 0.00929919 -0.00369561 0.0 +3166 3.55 3.65 161.25 -0.00326306 -0.00936525 0.00326349 0.00381045 0.00936578 -0.00381069 0.0 +3167 3.55 3.65 168.75 -0.00175148 -0.00841033 0.00175132 0.00358917 0.00841037 -0.00358917 0.0 +3168 3.55 3.65 176.25 -0.000592392 -0.007527 0.000592354 0.00335056 0.00752733 -0.00335069 0.0 +3169 3.65 2.55 3.75 -40.009 -15.4008 40.009 40.0274 15.4008 -40.0274 0.0 +3170 3.65 2.55 11.25 -35.9275 -8.01432 35.9275 33.2501 8.01432 -33.2501 0.0 +3171 3.65 2.55 18.75 -29.1111 2.18604 29.1111 25.2314 -2.18604 -25.2314 0.0 +3172 3.65 2.55 26.25 -21.3547 10.3626 21.3547 18.2796 -10.3626 -18.2796 0.0 +3173 3.65 2.55 33.75 -13.9719 14.348 13.9719 11.7967 -14.348 -11.7967 0.0 +3174 3.65 2.55 41.25 -7.5442 14.6453 7.54421 5.59102 -14.6453 -5.59102 0.0 +3175 3.65 2.55 48.75 -2.24061 13.0038 2.24061 0.431082 -13.0038 -0.431082 0.0 +3176 3.65 2.55 56.25 1.8288 11.0249 -1.8288 -2.89428 -11.0249 2.89428 0.0 +3177 3.65 2.55 63.75 4.53289 9.46602 -4.53289 -4.23204 -9.46602 4.23204 0.0 +3178 3.65 2.55 71.25 5.85495 8.2892 -5.85495 -4.06592 -8.2892 4.06592 0.0 +3179 3.65 2.55 78.75 6.02504 7.12145 -6.02504 -3.16889 -7.12145 3.16889 0.0 +3180 3.65 2.55 86.25 5.48507 5.68167 -5.48507 -2.21374 -5.68167 2.21374 0.0 +3181 3.65 2.55 93.75 4.69928 3.93064 -4.69928 -1.54457 -3.93064 1.54457 0.0 +3182 3.65 2.55 101.25 3.96919 2.00212 -3.96919 -1.18342 -2.00212 1.18342 0.0 +3183 3.65 2.55 108.75 3.38632 0.0868782 -3.38632 -0.988945 -0.0868777 0.988945 0.0 +3184 3.65 2.55 116.25 2.91224 -1.63935 -2.91224 -0.817586 1.63935 0.817586 0.0 +3185 3.65 2.55 123.75 2.48437 -3.04769 -2.48437 -0.599486 3.04769 0.599486 0.0 +3186 3.65 2.55 131.25 2.07217 -4.07177 -2.07217 -0.334193 4.07177 0.334193 0.0 +3187 3.65 2.55 138.75 1.67928 -4.7127 -1.67928 -0.0541061 4.7127 0.0541055 0.0 +3188 3.65 2.55 146.25 1.324 -5.02905 -1.324 0.206511 5.02905 -0.206511 0.0 +3189 3.65 2.55 153.75 1.02384 -5.11434 -1.02384 0.42501 5.11435 -0.425011 0.0 +3190 3.65 2.55 161.25 0.790618 -5.0708 -0.79062 0.59084 5.0708 -0.59084 0.0 +3191 3.65 2.55 168.75 0.631514 -4.98804 -0.631514 0.701038 4.98804 -0.701038 0.0 +3192 3.65 2.55 176.25 0.550863 -4.9302 -0.550863 0.755804 4.93019 -0.755804 0.0 +3193 3.65 2.65 3.75 -40.3415 -20.4462 40.3414 48.2003 20.4462 -48.2003 0.0 +3194 3.65 2.65 11.25 -35.6139 -12.537 35.6139 37.6321 12.537 -37.6321 0.0 +3195 3.65 2.65 18.75 -27.8935 -1.94676 27.8935 26.3964 1.94676 -26.3964 0.0 +3196 3.65 2.65 26.25 -19.4761 6.1859 19.4761 18.0571 -6.1859 -18.0571 0.0 +3197 3.65 2.65 33.75 -11.9713 9.93876 11.9713 11.3141 -9.93876 -11.3141 0.0 +3198 3.65 2.65 41.25 -5.94346 10.1979 5.94346 5.35283 -10.1979 -5.35283 0.0 +3199 3.65 2.65 48.75 -1.33924 8.87517 1.33925 0.645199 -8.87517 -0.645199 0.0 +3200 3.65 2.65 56.25 1.99711 7.47429 -1.99711 -2.21792 -7.47429 2.21792 0.0 +3201 3.65 2.65 63.75 4.13172 6.56384 -4.13172 -3.25512 -6.56384 3.25512 0.0 +3202 3.65 2.65 71.25 5.12808 5.97847 -5.12807 -3.03446 -5.97846 3.03446 0.0 +3203 3.65 2.65 78.75 5.18813 5.32387 -5.18814 -2.29047 -5.32387 2.29047 0.0 +3204 3.65 2.65 86.25 4.66497 4.36756 -4.66497 -1.57788 -4.36756 1.57788 0.0 +3205 3.65 2.65 93.75 3.92751 3.12819 -3.92751 -1.12411 -3.12819 1.12411 0.0 +3206 3.65 2.65 101.25 3.21269 1.76422 -3.21269 -0.893827 -1.76422 0.893826 0.0 +3207 3.65 2.65 108.75 2.59178 0.449106 -2.59178 -0.752929 -0.449104 0.752929 0.0 +3208 3.65 2.65 116.25 2.0428 -0.685103 -2.0428 -0.59797 0.685104 0.597969 0.0 +3209 3.65 2.65 123.75 1.53526 -1.55782 -1.53526 -0.396906 1.55781 0.396906 0.0 +3210 3.65 2.65 131.25 1.06531 -2.13944 -1.0653 -0.167518 2.13944 0.167517 0.0 +3211 3.65 2.65 138.75 0.647302 -2.44867 -0.6473 0.0582564 2.44867 -0.0582566 0.0 +3212 3.65 2.65 146.25 0.295526 -2.54219 -0.295526 0.256206 2.54219 -0.256206 0.0 +3213 3.65 2.65 153.75 0.015987 -2.49637 -0.0159868 0.414877 2.49637 -0.414877 0.0 +3214 3.65 2.65 161.25 -0.191615 -2.38798 0.191615 0.531758 2.38798 -0.531758 0.0 +3215 3.65 2.65 168.75 -0.329232 -2.2801 0.329232 0.608128 2.2801 -0.608129 0.0 +3216 3.65 2.65 176.25 -0.397947 -2.21557 0.397946 0.645792 2.21557 -0.645792 0.0 +3217 3.65 2.75 3.75 -39.2092 -22.6483 39.2092 57.4865 22.6483 -57.4865 0.0 +3218 3.65 2.75 11.25 -34.0902 -14.5832 34.0902 41.5462 14.5832 -41.5462 0.0 +3219 3.65 2.75 18.75 -25.8464 -4.11523 25.8464 26.3647 4.11523 -26.3647 0.0 +3220 3.65 2.75 26.25 -17.1522 3.55165 17.1522 16.7014 -3.55165 -16.7014 0.0 +3221 3.65 2.75 33.75 -9.84656 6.82027 9.84656 10.0278 -6.82027 -10.0278 0.0 +3222 3.65 2.75 41.25 -4.45564 6.92657 4.45564 4.64181 -6.92657 -4.64181 0.0 +3223 3.65 2.75 48.75 -0.70807 5.85889 0.708069 0.607165 -5.85889 -0.607165 0.0 +3224 3.65 2.75 56.25 1.80566 4.93589 -1.80566 -1.70515 -4.93589 1.70515 0.0 +3225 3.65 2.75 63.75 3.33924 4.49868 -3.33924 -2.44435 -4.49868 2.44435 0.0 +3226 3.65 2.75 71.25 4.02671 4.27839 -4.02671 -2.19705 -4.27839 2.19705 0.0 +3227 3.65 2.75 78.75 4.02726 3.91248 -4.02727 -1.60919 -3.91248 1.60919 0.0 +3228 3.65 2.75 86.25 3.58908 3.25589 -3.58908 -1.10369 -3.25589 1.10369 0.0 +3229 3.65 2.75 93.75 2.9762 2.39149 -2.9762 -0.808766 -2.39149 0.808766 0.0 +3230 3.65 2.75 101.25 2.36071 1.48535 -2.36071 -0.659115 -1.48535 0.659115 0.0 +3231 3.65 2.75 108.75 1.79777 0.671454 -1.79777 -0.545142 -0.671455 0.545142 0.0 +3232 3.65 2.75 116.25 1.28284 0.0234409 -1.28284 -0.404026 -0.0234405 0.404026 0.0 +3233 3.65 2.75 123.75 0.811743 -0.43038 -0.811744 -0.231178 0.43038 0.231178 0.0 +3234 3.65 2.75 131.25 0.396762 -0.692839 -0.396759 -0.0508027 0.692839 0.0508029 0.0 +3235 3.65 2.75 138.75 0.0525657 -0.79188 -0.0525663 0.112907 0.79188 -0.112907 0.0 +3236 3.65 2.75 146.25 -0.216914 -0.773428 0.216914 0.247559 0.773429 -0.247559 0.0 +3237 3.65 2.75 153.75 -0.418494 -0.689828 0.418494 0.351026 0.689828 -0.351026 0.0 +3238 3.65 2.75 161.25 -0.562315 -0.588117 0.562314 0.425709 0.588116 -0.425709 0.0 +3239 3.65 2.75 168.75 -0.655784 -0.50303 0.655784 0.474309 0.503029 -0.474309 0.0 +3240 3.65 2.75 176.25 -0.70215 -0.455711 0.702148 0.498348 0.45571 -0.498348 0.0 +3241 3.65 2.85 3.75 -36.1987 -22.1966 36.1987 67.8757 22.1966 -67.8757 0.0 +3242 3.65 2.85 11.25 -31.1231 -14.5476 31.1231 44.722 14.5476 -44.722 0.0 +3243 3.65 2.85 18.75 -22.9507 -4.83831 22.9507 25.1442 4.83831 -25.1442 0.0 +3244 3.65 2.85 26.25 -14.5015 1.99182 14.5015 14.4274 -1.99182 -14.4274 0.0 +3245 3.65 2.85 33.75 -7.74532 4.65105 7.74531 8.19298 -4.65105 -8.19298 0.0 +3246 3.65 2.85 41.25 -3.16789 4.58365 3.16789 3.66897 -4.58364 -3.66897 0.0 +3247 3.65 2.85 48.75 -0.326482 3.73795 0.326483 0.458076 -3.73795 -0.458076 0.0 +3248 3.65 2.85 56.25 1.38627 3.19238 -1.38627 -1.27721 -3.19238 1.27721 0.0 +3249 3.65 2.85 63.75 2.36943 3.06551 -2.36943 -1.75743 -3.06551 1.75743 0.0 +3250 3.65 2.85 71.25 2.8034 3.02746 -2.8034 -1.52065 -3.02746 1.52065 0.0 +3251 3.65 2.85 78.75 2.79373 2.78904 -2.79373 -1.08761 -2.78904 1.08761 0.0 +3252 3.65 2.85 86.25 2.48238 2.30604 -2.48238 -0.752322 -2.30604 0.752322 0.0 +3253 3.65 2.85 93.75 2.0349 1.7119 -2.0349 -0.569675 -1.71189 0.569675 0.0 +3254 3.65 2.85 101.25 1.56805 1.15837 -1.56805 -0.468524 -1.15836 0.468524 0.0 +3255 3.65 2.85 108.75 1.12682 0.726277 -1.12682 -0.371897 -0.726277 0.371897 0.0 +3256 3.65 2.85 116.25 0.721911 0.430298 -0.72191 -0.250757 -0.430296 0.250757 0.0 +3257 3.65 2.85 123.75 0.366105 0.255384 -0.366107 -0.115872 -0.255384 0.115872 0.0 +3258 3.65 2.85 131.25 0.0764133 0.178392 -0.0764139 0.0109956 -0.178395 -0.0109948 0.0 +3259 3.65 2.85 138.75 -0.140159 0.172548 0.140159 0.116179 -0.17255 -0.116179 0.0 +3260 3.65 2.85 146.25 -0.292185 0.208833 0.292184 0.197279 -0.208836 -0.197279 0.0 +3261 3.65 2.85 153.75 -0.396562 0.260566 0.396563 0.257879 -0.260565 -0.25788 0.0 +3262 3.65 2.85 161.25 -0.468221 0.308506 0.468223 0.301952 -0.308503 -0.301952 0.0 +3263 3.65 2.85 168.75 -0.515005 0.342587 0.515006 0.331407 -0.342587 -0.331407 0.0 +3264 3.65 2.85 176.25 -0.538677 0.359692 0.538675 0.346347 -0.359693 -0.346347 0.0 +3265 3.65 2.95 3.75 -31.0019 -19.003 31.0019 78.9744 19.003 -78.9744 0.0 +3266 3.65 2.95 11.25 -26.5858 -12.6408 26.5858 46.6915 12.6408 -46.6915 0.0 +3267 3.65 2.95 18.75 -19.2587 -4.5184 19.2587 22.835 4.51841 -22.835 0.0 +3268 3.65 2.95 26.25 -11.6633 1.10677 11.6633 11.5723 -1.10677 -11.5723 0.0 +3269 3.65 2.95 33.75 -5.7939 3.11687 5.79389 6.11985 -3.11686 -6.11985 0.0 +3270 3.65 2.95 41.25 -2.12727 2.91559 2.12727 2.63537 -2.91559 -2.63537 0.0 +3271 3.65 2.95 48.75 -0.137034 2.26979 0.137037 0.297769 -2.26979 -0.297769 0.0 +3272 3.65 2.95 56.25 0.89062 1.99985 -0.89062 -0.897052 -1.99985 0.897051 0.0 +3273 3.65 2.95 63.75 1.43386 2.04765 -1.43386 -1.17926 -2.04765 1.17926 0.0 +3274 3.65 2.95 71.25 1.68765 2.07234 -1.68766 -0.985761 -2.07234 0.985761 0.0 +3275 3.65 2.95 78.75 1.70109 1.87698 -1.70109 -0.696346 -1.87698 0.696346 0.0 +3276 3.65 2.95 86.25 1.52434 1.50326 -1.52434 -0.494147 -1.50326 0.494147 0.0 +3277 3.65 2.95 93.75 1.24419 1.10746 -1.24419 -0.388517 -1.10746 0.388517 0.0 +3278 3.65 2.95 101.25 0.937154 0.808793 -0.937155 -0.318937 -0.808791 0.318936 0.0 +3279 3.65 2.95 108.75 0.642843 0.634786 -0.642845 -0.240126 -0.634789 0.240127 0.0 +3280 3.65 2.95 116.25 0.381776 0.554629 -0.381776 -0.145979 -0.554627 0.14598 0.0 +3281 3.65 2.95 123.75 0.17295 0.527744 -0.17295 -0.0522492 -0.527741 0.0522488 0.0 +3282 3.65 2.95 131.25 0.0288148 0.525341 -0.0288157 0.0261916 -0.525345 -0.0261907 0.0 +3283 3.65 2.95 138.75 -0.0549588 0.529738 0.054956 0.0850404 -0.529738 -0.0850411 0.0 +3284 3.65 2.95 146.25 -0.0972437 0.529758 0.0972444 0.128089 -0.52976 -0.128088 0.0 +3285 3.65 2.95 153.75 -0.119472 0.520003 0.119472 0.16087 -0.520002 -0.16087 0.0 +3286 3.65 2.95 161.25 -0.13538 0.501774 0.135382 0.186492 -0.501775 -0.186491 0.0 +3287 3.65 2.95 168.75 -0.14865 0.481932 0.148652 0.205017 -0.481933 -0.205016 0.0 +3288 3.65 2.95 176.25 -0.156808 0.469103 0.156808 0.214928 -0.469103 -0.214928 0.0 +3289 3.65 3.05 3.75 -23.5214 -12.7722 23.5214 89.7571 12.7722 -89.7571 0.0 +3290 3.65 3.05 11.25 -20.5344 -8.89321 20.5344 46.7329 8.89321 -46.7329 0.0 +3291 3.65 3.05 18.75 -14.9237 -3.37015 14.9237 19.602 3.37015 -19.602 0.0 +3292 3.65 3.05 26.25 -8.79497 0.654416 8.79497 8.53398 -0.654415 -8.53398 0.0 +3293 3.65 3.05 33.75 -4.08878 2.00814 4.08878 4.118 -2.00814 -4.118 0.0 +3294 3.65 3.05 41.25 -1.34433 1.73251 1.34433 1.70123 -1.73252 -1.70123 0.0 +3295 3.65 3.05 48.75 -0.0691392 1.25993 0.0691406 0.177071 -1.25993 -0.177071 0.0 +3296 3.65 3.05 56.25 0.448 1.16617 -0.448 -0.563897 -1.16617 0.563897 0.0 +3297 3.65 3.05 63.75 0.688998 1.28795 -0.688995 -0.713807 -1.28795 0.713807 0.0 +3298 3.65 3.05 71.25 0.832696 1.31773 -0.8327 -0.581497 -1.31773 0.581496 0.0 +3299 3.65 3.05 78.75 0.879329 1.14394 -0.879329 -0.412977 -1.14394 0.412977 0.0 +3300 3.65 3.05 86.25 0.814193 0.858734 -0.814194 -0.307966 -0.858731 0.307966 0.0 +3301 3.65 3.05 93.75 0.671971 0.610837 -0.671969 -0.25422 -0.610837 0.25422 0.0 +3302 3.65 3.05 101.25 0.504261 0.479465 -0.50426 -0.20887 -0.479465 0.208869 0.0 +3303 3.65 3.05 108.75 0.347065 0.452085 -0.347066 -0.151081 -0.452085 0.151081 0.0 +3304 3.65 3.05 116.25 0.223383 0.474397 -0.22338 -0.0866915 -0.474392 0.0866907 0.0 +3305 3.65 3.05 123.75 0.149325 0.499837 -0.149326 -0.0298693 -0.499834 0.0298677 0.0 +3306 3.65 3.05 131.25 0.12772 0.50528 -0.127719 0.0117782 -0.505278 -0.0117784 0.0 +3307 3.65 3.05 138.75 0.143881 0.48447 -0.143884 0.0399674 -0.484471 -0.0399662 0.0 +3308 3.65 3.05 146.25 0.173862 0.43953 -0.173863 0.0607343 -0.439532 -0.0607346 0.0 +3309 3.65 3.05 153.75 0.197949 0.377853 -0.197948 0.0788534 -0.377854 -0.0788529 0.0 +3310 3.65 3.05 161.25 0.208419 0.311516 -0.20842 0.0954852 -0.311516 -0.0954856 0.0 +3311 3.65 3.05 168.75 0.208396 0.255395 -0.208397 0.108907 -0.255394 -0.108908 0.0 +3312 3.65 3.05 176.25 0.205537 0.223214 -0.205539 0.116501 -0.223214 -0.116501 0.0 +3313 3.65 3.15 3.75 -13.9561 -3.3206 13.9561 98.2858 3.3206 -98.2858 0.0 +3314 3.65 3.15 11.25 -13.261 -3.34518 13.261 43.9082 3.34518 -43.9082 0.0 +3315 3.65 3.15 18.75 -10.2101 -1.48319 10.2101 15.6336 1.48319 -15.6336 0.0 +3316 3.65 3.15 26.25 -6.06397 0.541479 6.06397 5.68372 -0.541479 -5.68372 0.0 +3317 3.65 3.15 33.75 -2.6902 1.22634 2.69021 2.43562 -1.22634 -2.43562 0.0 +3318 3.65 3.15 41.25 -0.799622 0.922855 0.799619 0.965754 -0.922853 -0.965755 0.0 +3319 3.65 3.15 48.75 -0.0595567 0.587691 0.0595571 0.105055 -0.58769 -0.105055 0.0 +3320 3.65 3.15 56.25 0.136132 0.582762 -0.136135 -0.296388 -0.582762 0.296388 0.0 +3321 3.65 3.15 63.75 0.206081 0.714041 -0.20608 -0.369864 -0.714043 0.369864 0.0 +3322 3.65 3.15 71.25 0.291262 0.735392 -0.29126 -0.298228 -0.735391 0.298228 0.0 +3323 3.65 3.15 78.75 0.359948 0.594925 -0.359946 -0.219047 -0.594924 0.219047 0.0 +3324 3.65 3.15 86.25 0.364864 0.394363 -0.36487 -0.178439 -0.39436 0.178439 0.0 +3325 3.65 3.15 93.75 0.314697 0.253059 -0.314697 -0.158716 -0.253058 0.158716 0.0 +3326 3.65 3.15 101.25 0.247244 0.215305 -0.247245 -0.133797 -0.215307 0.133798 0.0 +3327 3.65 3.15 108.75 0.19353 0.249334 -0.193531 -0.0978249 -0.249331 0.0978237 0.0 +3328 3.65 3.15 116.25 0.172327 0.299349 -0.17233 -0.0603582 -0.299354 0.0603583 0.0 +3329 3.65 3.15 123.75 0.191601 0.327027 -0.191602 -0.0313905 -0.327024 0.0313885 0.0 +3330 3.65 3.15 131.25 0.244296 0.319239 -0.244294 -0.0132263 -0.319245 0.0132287 0.0 +3331 3.65 3.15 138.75 0.309669 0.277854 -0.309668 -0.00163962 -0.277858 0.00164223 0.0 +3332 3.65 3.15 146.25 0.36466 0.210708 -0.36466 0.00886413 -0.210705 -0.00886437 0.0 +3333 3.65 3.15 153.75 0.396038 0.12897 -0.396036 0.0210449 -0.128967 -0.0210456 0.0 +3334 3.65 3.15 161.25 0.404322 0.0468919 -0.404325 0.034161 -0.0468877 -0.0341657 0.0 +3335 3.65 3.15 168.75 0.399467 -0.0197308 -0.399467 0.0454309 0.0197332 -0.045432 0.0 +3336 3.65 3.15 176.25 0.393288 -0.0570915 -0.393287 0.0519376 0.0570948 -0.0519383 0.0 +3337 3.65 3.25 3.75 -2.84841 8.98913 2.84841 101.365 -8.98913 -101.365 0.0 +3338 3.65 3.25 11.25 -5.30559 3.68427 5.30559 37.2625 -3.68427 -37.2625 0.0 +3339 3.65 3.25 18.75 -5.47905 1.03572 5.47905 11.105 -1.03572 -11.105 0.0 +3340 3.65 3.25 26.25 -3.63301 0.745278 3.63301 3.27944 -0.745278 -3.27944 0.0 +3341 3.65 3.25 33.75 -1.61937 0.737373 1.61937 1.21149 -0.737371 -1.21149 0.0 +3342 3.65 3.25 41.25 -0.451827 0.424127 0.451828 0.462362 -0.424126 -0.462367 0.0 +3343 3.65 3.25 48.75 -0.0643465 0.186784 0.064344 0.0665433 -0.186787 -0.0665438 0.0 +3344 3.65 3.25 56.25 -0.0271963 0.206749 0.0271963 -0.112307 -0.206747 0.112306 0.0 +3345 3.65 3.25 63.75 -0.0287216 0.314739 0.0287221 -0.147725 -0.314739 0.147727 0.0 +3346 3.65 3.25 71.25 0.0255212 0.334405 -0.0255227 -0.121627 -0.334405 0.121627 0.0 +3347 3.65 3.25 78.75 0.0934406 0.242453 -0.0934401 -0.0975277 -0.242456 0.0975275 0.0 +3348 3.65 3.25 86.25 0.124558 0.11911 -0.12456 -0.0934047 -0.119111 0.0934046 0.0 +3349 3.65 3.25 93.75 0.120536 0.0466826 -0.12054 -0.0939133 -0.0466836 0.0939132 0.0 +3350 3.65 3.25 101.25 0.110584 0.0476725 -0.110584 -0.0847896 -0.0476712 0.0847891 0.0 +3351 3.65 3.25 108.75 0.117935 0.090861 -0.117936 -0.0672303 -0.0908671 0.0672311 0.0 +3352 3.65 3.25 116.25 0.153275 0.133648 -0.153275 -0.0500874 -0.133656 0.0500894 0.0 +3353 3.65 3.25 123.75 0.215727 0.151238 -0.215728 -0.0391482 -0.151235 0.0391465 0.0 +3354 3.65 3.25 131.25 0.291608 0.138189 -0.291609 -0.0336619 -0.13819 0.0336617 0.0 +3355 3.65 3.25 138.75 0.359347 0.0983875 -0.359348 -0.0291956 -0.0983892 0.0291967 0.0 +3356 3.65 3.25 146.25 0.401272 0.038616 -0.401271 -0.022058 -0.0386123 0.0220571 0.0 +3357 3.65 3.25 153.75 0.412585 -0.0321809 -0.412584 -0.0116292 0.0321862 0.0116272 0.0 +3358 3.65 3.25 161.25 0.401401 -0.1024 -0.401399 4.51052e-05 0.102401 -4.42202e-05 0.0 +3359 3.65 3.25 168.75 0.382258 -0.159045 -0.38226 0.00995287 0.159044 -0.00995344 0.0 +3360 3.65 3.25 176.25 0.368774 -0.190698 -0.368775 0.0155765 0.190695 -0.0155759 0.0 +3361 3.65 3.35 3.75 8.57831 22.029 -8.57831 90.4039 -22.029 -90.4039 0.0 +3362 3.65 3.35 11.25 2.48876 10.9716 -2.48876 25.2009 -10.9716 -25.2009 0.0 +3363 3.65 3.35 18.75 -1.10374 3.77841 1.10374 5.92447 -3.77841 -5.92447 0.0 +3364 3.65 3.35 26.25 -1.58014 1.17267 1.58014 1.35603 -1.17267 -1.35603 0.0 +3365 3.65 3.35 33.75 -0.82821 0.490495 0.828207 0.439289 -0.490495 -0.43929 0.0 +3366 3.65 3.35 41.25 -0.237349 0.172633 0.237344 0.163569 -0.172631 -0.163569 0.0 +3367 3.65 3.35 48.75 -0.0586032 0.00522448 0.0586023 0.0404713 -0.00522588 -0.0404716 0.0 +3368 3.65 3.35 56.25 -0.0692222 0.0153302 0.0692185 -0.0129308 -0.0153248 0.0129318 0.0 +3369 3.65 3.35 63.75 -0.0840586 0.0871098 0.0840552 -0.0309457 -0.0871098 0.0309442 0.0 +3370 3.65 3.35 71.25 -0.0536445 0.110943 0.0536423 -0.0295495 -0.110941 0.0295495 0.0 +3371 3.65 3.35 78.75 -0.00982277 0.0701621 0.00982661 -0.0305352 -0.0701671 0.0305349 0.0 +3372 3.65 3.35 86.25 0.0145461 0.0088837 -0.0145485 -0.0406569 -0.00888549 0.040657 0.0 +3373 3.65 3.35 93.75 0.0229469 -0.0252769 -0.0229444 -0.0491129 0.025273 0.0491132 0.0 +3374 3.65 3.35 101.25 0.0355738 -0.0188163 -0.0355749 -0.0488332 0.0188197 0.0488329 0.0 +3375 3.65 3.35 108.75 0.0655018 0.0101297 -0.0655002 -0.0435205 -0.0101327 0.0435213 0.0 +3376 3.65 3.35 116.25 0.115214 0.0376575 -0.115217 -0.0395796 -0.0376578 0.0395802 0.0 +3377 3.65 3.35 123.75 0.178049 0.0506336 -0.17805 -0.0391484 -0.0506349 0.0391483 0.0 +3378 3.65 3.35 131.25 0.238684 0.0459317 -0.238686 -0.0397537 -0.0459383 0.0397562 0.0 +3379 3.65 3.35 138.75 0.279372 0.0244903 -0.27937 -0.0377474 -0.0244898 0.0377484 0.0 +3380 3.65 3.35 146.25 0.29001 -0.0110173 -0.290012 -0.0314691 0.0110121 0.0314721 0.0 +3381 3.65 3.35 153.75 0.273314 -0.0554592 -0.273313 -0.0220115 0.0554597 0.0220096 0.0 +3382 3.65 3.35 161.25 0.241753 -0.100943 -0.241753 -0.0119952 0.100943 0.0119956 0.0 +3383 3.65 3.35 168.75 0.210527 -0.138246 -0.210527 -0.00397578 0.138246 0.0039749 0.0 +3384 3.65 3.35 176.25 0.191739 -0.15925 -0.191737 0.000392892 0.159255 -0.000394892 0.0 +3385 3.65 3.45 3.75 13.9352 25.0134 -13.9352 47.3581 -25.0134 -47.3581 0.0 +3386 3.65 3.45 11.25 6.6144 12.841 -6.6144 7.54163 -12.841 -7.54163 0.0 +3387 3.65 3.45 18.75 1.63977 4.65277 -1.63978 0.626067 -4.65277 -0.626067 0.0 +3388 3.65 3.45 26.25 -0.134965 1.26549 0.134964 -0.00630213 -1.26549 0.0063021 0.0 +3389 3.65 3.45 33.75 -0.257019 0.327565 0.257018 0.0506325 -0.327565 -0.0506314 0.0 +3390 3.65 3.45 41.25 -0.0878206 0.0755859 0.0878219 0.0249344 -0.0755854 -0.0249345 0.0 +3391 3.65 3.45 48.75 -0.0295997 -0.0171818 0.0296009 0.0154182 0.0171825 -0.0154176 0.0 +3392 3.65 3.45 56.25 -0.0349652 -0.0219445 0.0349652 0.0129602 0.0219435 -0.0129587 0.0 +3393 3.65 3.45 63.75 -0.0407381 0.00761187 0.0407386 0.00421853 -0.00761128 -0.00421831 0.0 +3394 3.65 3.45 71.25 -0.034214 0.0259423 0.0342165 7.51679e-05 -0.0259422 -7.45622e-05 0.0 +3395 3.65 3.45 78.75 -0.0246565 0.0206849 0.0246588 -0.00385973 -0.0206858 0.00385946 0.0 +3396 3.65 3.45 86.25 -0.0199608 0.00260566 0.0199588 -0.0108228 -0.00260582 0.0108228 0.0 +3397 3.65 3.45 93.75 -0.0160962 -0.0108235 0.0160951 -0.0154515 0.0108225 0.0154515 0.0 +3398 3.65 3.45 101.25 -0.00516199 -0.0109817 0.00516255 -0.0158667 0.0109834 0.015867 0.0 +3399 3.65 3.45 108.75 0.0161436 -0.000990441 -0.0161444 -0.0157139 0.000992657 0.0157131 0.0 +3400 3.65 3.45 116.25 0.0462359 0.0119933 -0.0462349 -0.0179074 -0.011993 0.0179074 0.0 +3401 3.65 3.45 123.75 0.0789796 0.0222832 -0.0789806 -0.0216543 -0.0222854 0.0216552 0.0 +3402 3.65 3.45 131.25 0.104194 0.0261517 -0.104194 -0.0240943 -0.02615 0.0240937 0.0 +3403 3.65 3.45 138.75 0.112387 0.02152 -0.112387 -0.0230795 -0.0215204 0.0230794 0.0 +3404 3.65 3.45 146.25 0.100783 0.00855296 -0.100781 -0.01859 -0.00855206 0.01859 0.0 +3405 3.65 3.45 153.75 0.0747866 -0.010086 -0.0747873 -0.0122934 0.0100866 0.0122928 0.0 +3406 3.65 3.45 161.25 0.0443158 -0.0300182 -0.0443169 -0.0062199 0.0300166 0.00622007 0.0 +3407 3.65 3.45 168.75 0.0188579 -0.0465341 -0.0188583 -0.00176027 0.0465354 0.00175935 0.0 +3408 3.65 3.45 176.25 0.0047077 -0.0558365 -0.0047082 0.000519921 0.055837 -0.000521264 0.0 +3409 3.65 3.55 3.75 9.08664 14.1707 -9.08664 5.00548 -14.1707 -5.00548 0.0 +3410 3.65 3.55 11.25 4.57491 7.32707 -4.57491 -2.27541 -7.32707 2.27541 0.0 +3411 3.65 3.55 18.75 1.46185 2.72587 -1.46185 -1.40671 -2.72587 1.40671 0.0 +3412 3.65 3.55 26.25 0.202401 0.72718 -0.2024 -0.363615 -0.72718 0.363615 0.0 +3413 3.65 3.55 33.75 -0.0292135 0.158386 0.029214 -0.0296083 -0.158386 0.0296077 0.0 +3414 3.65 3.55 41.25 -0.013327 0.0341023 0.0133271 0.000415071 -0.0341024 -0.000414506 0.0 +3415 3.65 3.55 48.75 -0.00386995 0.00137162 0.00387057 0.00354997 -0.00137196 -0.00354995 0.0 +3416 3.65 3.55 56.25 -0.00362953 -0.00381371 0.00363005 0.00491999 0.00381369 -0.00492036 0.0 +3417 3.65 3.55 63.75 -0.00367255 0.000623919 0.00367258 0.000772869 -0.000624073 -0.000773243 0.0 +3418 3.65 3.55 71.25 -0.00599085 0.00545353 0.00599175 -0.000877382 -0.00545427 0.000877255 0.0 +3419 3.65 3.55 78.75 -0.00914792 0.00752484 0.00914884 -0.00123739 -0.00752489 0.00123748 0.0 +3420 3.65 3.55 86.25 -0.0111926 0.00607339 0.0111914 -0.00180791 -0.00607396 0.00180784 0.0 +3421 3.65 3.55 93.75 -0.0109307 0.00306489 0.0109307 -0.00110181 -0.00306532 0.00110186 0.0 +3422 3.65 3.55 101.25 -0.0077646 0.00146913 0.00776434 0.000281463 -0.00146817 -0.000281676 0.0 +3423 3.65 3.55 108.75 -0.00177445 0.00282649 0.00177504 0.000276509 -0.00282655 -0.00027648 0.0 +3424 3.65 3.55 116.25 0.00630219 0.00656393 -0.00630239 -0.00161604 -0.0065638 0.00161557 0.0 +3425 3.65 3.55 123.75 0.0142754 0.0104985 -0.0142748 -0.00404929 -0.0104982 0.00404958 0.0 +3426 3.65 3.55 131.25 0.0185262 0.0121463 -0.0185258 -0.00537147 -0.0121454 0.00537123 0.0 +3427 3.65 3.55 138.75 0.016205 0.0102423 -0.0162052 -0.00485693 -0.0102423 0.00485692 0.0 +3428 3.65 3.55 146.25 0.00744851 0.00528258 -0.00744923 -0.00289648 -0.00528247 0.00289629 0.0 +3429 3.65 3.55 153.75 -0.0047483 -0.0011129 0.0047475 -0.000439985 0.00111111 0.000440653 0.0 +3430 3.65 3.55 161.25 -0.0165726 -0.00720789 0.0165725 0.00167706 0.00720864 -0.00167778 0.0 +3431 3.65 3.55 168.75 -0.0252959 -0.0117744 0.0252957 0.00306582 0.0117749 -0.00306615 0.0 +3432 3.65 3.55 176.25 -0.0297657 -0.0141745 0.0297651 0.00371221 0.0141748 -0.00371261 0.0 +3433 3.65 3.65 3.75 1.34179 1.8764 -1.34179 -2.21207 -1.8764 2.21207 0.0 +3434 3.65 3.65 11.25 0.674722 0.975627 -0.674722 -1.01114 -0.975627 1.01114 0.0 +3435 3.65 3.65 18.75 0.218094 0.365855 -0.218094 -0.384938 -0.365855 0.384938 0.0 +3436 3.65 3.65 26.25 0.034533 0.0959486 -0.034533 -0.0883541 -0.0959486 0.0883541 0.0 +3437 3.65 3.65 33.75 0.000906004 0.0183831 -0.000905993 -0.00778172 -0.0183832 0.00778172 0.0 +3438 3.65 3.65 41.25 0.00132048 0.00271731 -0.00132051 0.00071098 -0.00271729 -0.000710997 0.0 +3439 3.65 3.65 48.75 0.000821636 -0.000306112 -0.00082155 0.000743727 0.000306079 -0.000743719 0.0 +3440 3.65 3.65 56.25 0.00055949 -0.000894959 -0.000559485 0.000325653 0.000894939 -0.000325638 0.0 +3441 3.65 3.65 63.75 0.000919031 -0.00134167 -0.000918928 -0.000425567 0.0013417 0.000425618 0.0 +3442 3.65 3.65 71.25 0.00068388 -0.00161126 -0.000683975 -0.000595268 0.00161117 0.000595242 0.0 +3443 3.65 3.65 78.75 0.000214632 -0.00126472 -0.000214751 -0.000489084 0.00126474 0.000489099 0.0 +3444 3.65 3.65 86.25 8.67817e-06 -0.000701107 -8.75836e-06 -0.000274181 0.00070111 0.000274184 0.0 +3445 3.65 3.65 93.75 1.71384e-06 -0.000443281 -1.76788e-06 0.000154524 0.000443329 -0.000154528 0.0 +3446 3.65 3.65 101.25 1.95029e-05 -0.000477718 -1.95794e-05 0.000567489 0.000477841 -0.000567493 0.0 +3447 3.65 3.65 108.75 7.48783e-05 -0.00049436 -7.48748e-05 0.000683729 0.000494453 -0.000683746 0.0 +3448 3.65 3.65 116.25 0.000265232 -0.000391767 -0.000265328 0.00052426 0.000391822 -0.000524261 0.0 +3449 3.65 3.65 123.75 0.000509939 -0.000400182 -0.000509922 0.000310119 0.000400276 -0.000310147 0.0 +3450 3.65 3.65 131.25 0.000525607 -0.000787876 -0.000525615 0.000228989 0.000787858 -0.00022897 0.0 +3451 3.65 3.65 138.75 0.000108536 -0.00156718 -0.000108471 0.000330074 0.00156723 -0.000330079 0.0 +3452 3.65 3.65 146.25 -0.000640149 -0.00249673 0.000640125 0.000548861 0.00249673 -0.000548895 0.0 +3453 3.65 3.65 153.75 -0.0014021 -0.00329158 0.00140212 0.000784814 0.00329161 -0.000784826 0.0 +3454 3.65 3.65 161.25 -0.00190979 -0.00380299 0.00190977 0.000966445 0.00380303 -0.000966483 0.0 +3455 3.65 3.65 168.75 -0.00211603 -0.00404799 0.00211605 0.00107292 0.004048 -0.00107292 0.0 +3456 3.65 3.65 176.25 -0.00215132 -0.00412886 0.00215137 0.00111754 0.00412895 -0.00111757 0.0 diff --git a/unittest/force-styles/tests/atomic-pair-sw_angle_table.yaml b/unittest/force-styles/tests/atomic-pair-sw_angle_table.yaml new file mode 100644 index 0000000000..b8eae7848b --- /dev/null +++ b/unittest/force-styles/tests/atomic-pair-sw_angle_table.yaml @@ -0,0 +1,97 @@ +--- +lammps_version: 4 May 2022 +tags: generated +date_generated: Wed Jun 1 15:17:22 2022 +epsilon: 1e-12 +skip_tests: single +prerequisites: ! | + pair sw/angle/table + pair table +pre_commands: ! | + variable units index real + variable newton_pair delete + variable newton_pair index on + shell cp ${input_dir}/table_CG_CG_CG.txt . +post_commands: ! "" +input_file: in.metal +pair_style: hybrid/overlay table linear 1200 sw/angle/table +pair_coeff: ! | + * * table ${input_dir}/table_CG_CG.txt VOTCA + * * sw/angle/table ${input_dir}/spce.sw type type +extract: ! "" +natoms: 32 +init_vdwl: 2428.9633428241673 +init_coul: 0 +init_stress: ! |2- + 2.1799808252981104e+04 2.2098847758334741e+04 1.5227317495796946e+04 5.5915487284825185e+03 4.2330141376182507e+02 -2.1635648030093221e+03 +init_forces: ! |2 + 1 -3.5272456427265922e+02 4.7896703188444229e+02 7.6160632749768567e+01 + 2 -2.2734507500176406e+01 -1.5821645847684510e+02 1.1028261572305695e+02 + 3 -3.6932223674029137e+02 1.7315628979419187e+03 -5.2288079251214720e+02 + 4 3.1116044194470057e+01 -3.1009878149268530e+01 -6.8414290700926671e+01 + 5 1.2157567668233901e+03 1.3361425827696451e+03 -2.4428700622833938e+02 + 6 2.1498603159595226e+02 1.2379258234822432e+01 -1.8192892150594932e+02 + 7 -5.8065242995364076e+02 6.3615913954340272e+02 -5.8940661342540871e+01 + 8 -2.9330102622037936e+02 -1.4478456371145094e+02 3.4992669050834974e+02 + 9 5.4581529315399578e+01 -1.0085658890730177e+02 -4.3539166606697755e+01 + 10 -7.5328757518773557e+02 -1.9208550331031577e+03 -5.9929086772884966e+02 + 11 -6.2073979508185595e+01 -9.3172505877146349e+01 8.8201736909256510e+01 + 12 5.2022495622775352e+02 -6.4668600468680108e+02 -1.8086255931588799e+01 + 13 -1.4637585277113917e+02 -2.4193749312797078e+01 -1.3497675472534843e+02 + 14 2.2785633726795228e+02 -1.4050021950202930e+02 4.2957377860079254e+02 + 15 -4.1589593903912913e+01 5.6849936807240290e+01 -5.3315771137404397e+01 + 16 5.0207265346701280e+02 -4.3553084670415353e+02 2.2270110539464073e+02 + 17 2.7243217976852867e+02 6.7842110608020960e+02 -1.8488293016613730e+02 + 18 -1.6339467540544510e+03 -8.6208840396403559e+02 -5.2809809085219297e+02 + 19 -1.8146991394127588e+03 -1.4248970633821093e+03 1.6246778777497133e+02 + 20 5.0143947854312678e+01 3.0349353798587607e+01 -7.6753179337391444e+01 + 21 1.1359392702527382e+03 6.7780617382057903e+02 -2.1777379118829096e+01 + 22 2.6318213617558456e+01 -1.1442799194941128e+02 -4.0723882345600529e+01 + 23 1.0173532367943421e+03 1.4870722398544501e+03 -3.3061556638580618e+02 + 24 1.8951324945224176e+03 1.3655558041004167e+03 6.3746947970957035e+02 + 25 2.1139286860441129e+02 -1.4343085616543428e+02 -2.4472193090284622e+02 + 26 -6.6054117554868481e+02 -1.7214679588856484e+03 1.1872792057456782e+03 + 27 3.8554823693482177e+02 -2.4263768110018356e+02 -1.4505783275426307e+01 + 28 -1.6156920382667545e+02 3.2681073686927527e+02 4.0195534333261003e+02 + 29 1.0269877810330740e+03 1.0972018261937728e+03 -4.9239365569732279e+01 + 30 -7.7183246664884393e+01 -1.1163723935859770e+02 -5.6015149765282524e+02 + 31 2.7330076741933460e+01 -6.2134053241130312e+02 3.7926314422192496e+02 + 32 -1.8451713394504984e+03 -9.7754451225108528e+02 -6.8151426644039077e+01 +run_vdwl: 2428.764401023566 +run_coul: 0 +run_stress: ! |2- + 2.1807179009069081e+04 2.2096249577665836e+04 1.5217251424717178e+04 5.5876293741471409e+03 4.2481794037948595e+02 -2.1641073132805273e+03 +run_forces: ! |2 + 1 -3.5657232205619187e+02 4.8051759317525114e+02 7.4589821279043520e+01 + 2 -2.2890330563537752e+01 -1.5847929947391452e+02 1.1057024581491029e+02 + 3 -3.7048240284136381e+02 1.7274339155425446e+03 -5.2721183867080663e+02 + 4 3.1213113517876284e+01 -3.0972108629752253e+01 -6.8362160774369471e+01 + 5 1.2131778379678060e+03 1.3324719919494626e+03 -2.4196312117000102e+02 + 6 2.1588387878389867e+02 1.2017400433555963e+01 -1.8323099068613300e+02 + 7 -5.8298397256607473e+02 6.3858638821865122e+02 -5.9272595884065503e+01 + 8 -2.9450691866540427e+02 -1.4488601302098704e+02 3.5084177622838757e+02 + 9 5.5071730152343321e+01 -1.0126346692429934e+02 -4.3948685147789718e+01 + 10 -7.4709028759946739e+02 -1.9173399004644243e+03 -5.9495231666550546e+02 + 11 -6.1959233740417524e+01 -9.3373357444258517e+01 8.7926257027673998e+01 + 12 5.2278142223716191e+02 -6.4849088771234563e+02 -1.8113808074276363e+01 + 13 -1.4714650249643290e+02 -2.5131629765603009e+01 -1.3479374072464537e+02 + 14 2.2857040301009684e+02 -1.3768541975979431e+02 4.2806018886113947e+02 + 15 -4.1477060277693703e+01 5.7115876564426109e+01 -5.3039366059682528e+01 + 16 4.9944201304657383e+02 -4.3383072035483559e+02 2.2091297501303973e+02 + 17 2.7228851840542382e+02 6.7799738753924669e+02 -1.8446508468678948e+02 + 18 -1.6336221792482595e+03 -8.5972791234834551e+02 -5.2898505983077177e+02 + 19 -1.8135957890859013e+03 -1.4238141052528933e+03 1.6225337159545035e+02 + 20 5.0092828583367634e+01 3.0471251647078265e+01 -7.6722240263741099e+01 + 21 1.1355438484696886e+03 6.7519841904221255e+02 -2.0182855479720033e+01 + 22 2.6571960650017800e+01 -1.1420696745726380e+02 -4.0529746043707348e+01 + 23 1.0263737261398123e+03 1.4932072283307180e+03 -3.2636823427367165e+02 + 24 1.8952730712010357e+03 1.3642712022544688e+03 6.3847090965522716e+02 + 25 2.1193565520738500e+02 -1.4318069871618528e+02 -2.4487119695300959e+02 + 26 -6.5812362830257700e+02 -1.7188102078185152e+03 1.1859492616184705e+03 + 27 3.8565010020982788e+02 -2.4238978364677456e+02 -1.4837594446360082e+01 + 28 -1.6123154438363622e+02 3.2723676308792528e+02 4.0126611479067810e+02 + 29 1.0251768164068674e+03 1.0954706244344939e+03 -4.9292343676448787e+01 + 30 -7.7077129341229522e+01 -1.1123357160671468e+02 -5.6043482841374544e+02 + 31 2.5726118886179297e+01 -6.2166714125994793e+02 3.8003828834174129e+02 + 32 -1.8520137417071724e+03 -9.8551285056318022e+02 -6.9301402300522653e+01 +... diff --git a/unittest/force-styles/tests/atomic-pair-threebody_table.yaml b/unittest/force-styles/tests/atomic-pair-threebody_table.yaml new file mode 100644 index 0000000000..605f18a9a6 --- /dev/null +++ b/unittest/force-styles/tests/atomic-pair-threebody_table.yaml @@ -0,0 +1,98 @@ +--- +lammps_version: 4 May 2022 +tags: generated +date_generated: Wed Jun 1 15:28:13 2022 +epsilon: 1e-05 +skip_tests: single +prerequisites: ! | + pair threebody/table + pair table +pre_commands: ! | + variable units index real + variable newton_pair delete + variable newton_pair index on + shell cp ${input_dir}/1-1-1.table . + shell cp ${input_dir}/1-1-2.table . +post_commands: ! "" +input_file: in.metal +pair_style: hybrid/overlay table linear 1200 threebody/table +pair_coeff: ! | + * * table ${input_dir}/table_CG_CG.txt VOTCA + * * threebody/table ${input_dir}/spce2.3b type1 type2 +extract: ! "" +natoms: 32 +init_vdwl: 1491.9850663210582 +init_coul: 0 +init_stress: ! |2- + 2.1388163370760823e+04 2.1664558645983379e+04 1.4729243404366314e+04 5.6495516964437775e+03 5.1637900223635859e+02 -2.2491014848350428e+03 +init_forces: ! |2 + 1 -3.4809429741393029e+02 4.6567597414239913e+02 9.4441973687110405e+01 + 2 -1.8412192720214428e+01 -1.6122507911305391e+02 1.1798397229543718e+02 + 3 -3.6959552927057359e+02 1.7366664628134174e+03 -5.2433878744101696e+02 + 4 1.9704833162904933e+01 -2.8473480842310366e+01 -7.6632873700899410e+01 + 5 1.2286660791793993e+03 1.3189646599149826e+03 -2.5750328829062335e+02 + 6 2.3230773636573508e+02 1.3236909769358112e+01 -1.6536673989911372e+02 + 7 -5.9250555047871524e+02 6.4419772822168966e+02 -7.3421471775369668e+01 + 8 -2.7993451614515635e+02 -1.3398848087050882e+02 3.4786818228776917e+02 + 9 6.0102535250319256e+01 -8.2958743522890487e+01 -4.2554780357129808e+01 + 10 -7.7091710125156442e+02 -1.9316366702146124e+03 -5.7574889508217711e+02 + 11 -6.6141742740805213e+01 -8.9045678804585251e+01 9.2760444861105910e+01 + 12 5.3526455218407943e+02 -6.5780369404995440e+02 -9.4845914108869884e+00 + 13 -1.6564083090865202e+02 -2.1519923677640854e+01 -1.3123092115579615e+02 + 14 2.3337854905367016e+02 -1.1893053800382607e+02 4.3706653618942192e+02 + 15 -4.7292738629250245e+01 6.1031002391688908e+01 -4.2739580007555375e+01 + 16 5.0083107755149183e+02 -4.2750321084667428e+02 2.3013161197871258e+02 + 17 2.9344728675986164e+02 6.8063155134388398e+02 -1.9478515772339574e+02 + 18 -1.6545067282255825e+03 -8.7660521680902912e+02 -5.2486018536431391e+02 + 19 -1.7992841953748712e+03 -1.4223424241054529e+03 1.3975194023223264e+02 + 20 5.3624371129881432e+01 4.2727424976681945e+01 -7.2478104483156997e+01 + 21 1.0897088707455639e+03 7.2603975137317627e+02 -5.1120443430894568e+01 + 22 2.9564358575254730e+01 -1.1955500923091164e+02 -5.6658561557696522e+01 + 23 1.0024095663866029e+03 1.4815830194767184e+03 -3.4241061954729582e+02 + 24 1.8958818608698684e+03 1.3513089573990835e+03 6.4474764645157461e+02 + 25 2.1916799984257568e+02 -1.3480959959762640e+02 -2.5143909195778633e+02 + 26 -6.7819370861387029e+02 -1.7332731917983826e+03 1.1759045104066886e+03 + 27 3.9534539412579926e+02 -2.5831579543312483e+02 -3.0068663848303565e+01 + 28 -1.7049475634836011e+02 3.0557653380225258e+02 3.9667516538156866e+02 + 29 1.0124807267829628e+03 1.0704993768753102e+03 -6.6827000765975839e+01 + 30 -6.0958426550901464e+01 -1.2048001317378247e+02 -5.4659311407722760e+02 + 31 2.7988221050038256e+01 -6.0346016941066136e+02 3.8578368661473195e+02 + 32 -1.8079021293566357e+03 -9.7620852873268325e+02 -2.6848072654532874e+01 +run_vdwl: 1491.7709826398068 +run_coul: 0 +run_stress: ! |2- + 2.1425064502585417e+04 2.1669158423280089e+04 1.4747818832883342e+04 5.6707077802984231e+03 5.4904652273389740e+02 -2.2288016407219948e+03 +run_forces: ! |2 + 1 -3.5191405522221208e+02 4.6719496439671821e+02 9.5160203317446630e+01 + 2 -1.8514912253517174e+01 -1.6167539395717191e+02 1.1813103212569202e+02 + 3 -3.7131956856014324e+02 1.7323797805692438e+03 -5.3074350641727199e+02 + 4 1.9443697338922082e+01 -2.8705869694043574e+01 -7.6619749545143492e+01 + 5 1.2260941309164493e+03 1.3152677694284498e+03 -2.5516802038260235e+02 + 6 2.3322089165638701e+02 1.2862869405899247e+01 -1.6667928243690179e+02 + 7 -5.9486664911064634e+02 6.4667229208938795e+02 -7.3770515588557785e+01 + 8 -2.8115980510834169e+02 -1.3411610929266357e+02 3.4879265918581427e+02 + 9 6.0619815294130184e+01 -8.3407515617420799e+01 -4.2999027435430953e+01 + 10 -7.6429388783007221e+02 -1.9278828213213337e+03 -5.7135063514687909e+02 + 11 -6.6016349831195143e+01 -8.9273528569753211e+01 9.2448231530143218e+01 + 12 5.3785966085411701e+02 -6.5959880855240010e+02 -9.4946135547062909e+00 + 13 -1.6641765862714641e+02 -2.2476690068776783e+01 -1.3101354808256795e+02 + 14 2.3412385380018750e+02 -1.1604834858772836e+02 4.3551831586668749e+02 + 15 -4.7170704261276846e+01 6.1314362285436715e+01 -4.2456307464845409e+01 + 16 4.9810572379063296e+02 -4.2579585263982955e+02 2.2832018077001956e+02 + 17 2.8312588438935751e+02 6.6818248758640414e+02 -2.0387201756671962e+02 + 18 -1.6531905535811466e+03 -8.7325660040293678e+02 -5.2578287557408930e+02 + 19 -1.7717540076086393e+03 -1.4078190114507104e+03 1.5867151421748673e+02 + 20 5.3592891283041261e+01 4.2790401518478163e+01 -7.2482601253922383e+01 + 21 1.0838596264146349e+03 7.2319003723887010e+02 -4.8376931553139812e+01 + 22 2.9966891580030588e+01 -1.1952124544144279e+02 -5.6490752521580006e+01 + 23 1.0114992761256929e+03 1.4877360943225701e+03 -3.3815548489754946e+02 + 24 1.8960185852616901e+03 1.3500190426973886e+03 6.4578239684187895e+02 + 25 2.1972099306244061e+02 -1.3453156341222555e+02 -2.5160650947118697e+02 + 26 -6.7764066859903267e+02 -1.7320367725724675e+03 1.1718183638063283e+03 + 27 3.9544661983654925e+02 -2.5857342971810368e+02 -3.0379689818002142e+01 + 28 -1.7960213685989305e+02 3.0633168671228430e+02 3.8807838388686309e+02 + 29 1.0106463589881000e+03 1.0687745018889480e+03 -6.6861303703586529e+01 + 30 -6.0852844150139362e+01 -1.2007219497990148e+02 -5.4687005523315872e+02 + 31 2.6341847548417515e+01 -6.0380405513895437e+02 3.8656694437683996e+02 + 32 -1.8149728033842284e+03 -9.8411584459831852e+02 -2.8109959690485834e+01 +... diff --git a/unittest/force-styles/tests/spce.sw b/unittest/force-styles/tests/spce.sw new file mode 100644 index 0000000000..8b0fd70f61 --- /dev/null +++ b/unittest/force-styles/tests/spce.sw @@ -0,0 +1,18 @@ +type +type +type +1 #epsilon in kcal/mol +1 #sigma in dimensionless +3.7 # a in Ang +1.0 #lambda dimensionless +0.8 #gamma in Ang +0.0 #costheta0 dimensionless +0 #two body part A=0 +0 #two body part B=0 +0 #two body part p=0 +0 #two body part q=0 +0.0 # use the standard Stillinger-Weber cutoff +table_CG_CG_CG.txt +VOTCA +linear +1001 diff --git a/unittest/force-styles/tests/spce2.3b b/unittest/force-styles/tests/spce2.3b new file mode 100644 index 0000000000..52fcd1e5e9 --- /dev/null +++ b/unittest/force-styles/tests/spce2.3b @@ -0,0 +1,71 @@ +type1 +type1 +type1 +3.7 # cut in Ang +1-1-1.table +ENTRY1 +linear +12 +type1 +type1 +type2 +3.7 # cut in Ang +1-1-2.table +ENTRY1 +linear +12 +type1 +type2 +type1 +3.7 # cut in Ang +1-1-2.table +ENTRY1 +linear +12 +type1 +type2 +type2 +3.7 # cut in Ang +1-1-1.table +ENTRY1 +linear +12 +type2 +type1 +type1 +3.7 # cut in Ang +1-1-1.table +ENTRY1 +linear +12 +type2 +type1 +type2 +3.7 # cut in Ang +1-1-2.table +ENTRY1 +linear +12 +type2 +type2 +type1 +3.7 # cut in Ang +1-1-2.table +ENTRY1 +linear +12 +type2 +type2 +type2 +3.7 # cut in Ang +1-1-1.table +ENTRY1 +linear +12 + + + + + + + diff --git a/unittest/force-styles/tests/table_CG_CG.txt b/unittest/force-styles/tests/table_CG_CG.txt new file mode 100644 index 0000000000..f4ccdd4b4e --- /dev/null +++ b/unittest/force-styles/tests/table_CG_CG.txt @@ -0,0 +1,1203 @@ +VOTCA +N 1200 R 0.010000 12.000000 + +1 1.0000000000e-02 1.5390100510e+15 2.1517330910e+16 +2 2.0000000000e-02 1.3370836560e+15 1.8774943350e+16 +3 3.0000000000e-02 1.1616510900e+15 1.6231560530e+16 +4 4.0000000000e-02 1.0092362200e+15 1.4101892510e+16 +5 5.0000000000e-02 8.7681900090e+14 1.2251648380e+16 +6 6.0000000000e-02 7.6177563290e+14 1.0644166230e+16 +7 7.0000000000e-02 6.6182657340e+14 9.2475943770e+15 +8 8.0000000000e-02 5.7499136800e+14 8.0342602660e+15 +9 9.0000000000e-02 4.9954940840e+14 6.9801221150e+15 +10 1.0000000000e-01 4.3400583970e+14 6.0642925570e+15 +11 1.1000000000e-01 3.7706193970e+14 5.2686247630e+15 +12 1.2000000000e-01 3.2758938550e+14 4.5773528620e+15 +13 1.3000000000e-01 2.8460789650e+14 3.9767795520e+15 +14 1.4000000000e-01 2.4726581000e+14 3.4550046890e+15 +15 1.5000000000e-01 2.1482320610e+14 3.0016894950e+15 +16 1.6000000000e-01 1.8663724620e+14 2.6078516910e+15 +17 1.7000000000e-01 1.6214943590e+14 2.2656875260e+15 +18 1.8000000000e-01 1.4087455790e+14 1.9684171380e+15 +19 1.9000000000e-01 1.2239105840e+14 1.7101502250e+15 +20 2.0000000000e-01 1.0633269330e+14 1.4857693190e+15 +21 2.1000000000e-01 9.2381272170e+13 1.2908283940e+15 +22 2.2000000000e-01 8.0260352480e+13 1.1214647680e+15 +23 2.3000000000e-01 6.9729762630e+13 9.7432255940e+14 +24 2.4000000000e-01 6.0580842800e+13 8.4648620020e+14 +25 2.5000000000e-01 5.2632310450e+13 7.3542265870e+14 +26 2.6000000000e-01 4.5726668290e+13 6.3893125110e+14 +27 2.7000000000e-01 3.9727083510e+13 5.5510003510e+14 +28 2.8000000000e-01 3.4514676520e+13 4.8226792540e+14 +29 2.9000000000e-01 2.9986165360e+13 4.1899178020e+14 +30 3.0000000000e-01 2.6051819210e+13 3.6401780550e+14 +31 3.1000000000e-01 2.2633680440e+13 3.1625671190e+14 +32 3.2000000000e-01 1.9664019850e+13 2.7476213060e+14 +33 3.3000000000e-01 1.7083994700e+13 2.3871186160e+14 +34 3.4000000000e-01 1.4842482730e+13 2.0739158160e+14 +35 3.5000000000e-01 1.2895069180e+13 1.8018069090e+14 +36 3.6000000000e-01 1.1203166760e+13 1.5654001530e+14 +37 3.7000000000e-01 9.7332510350e+12 1.3600112350e+14 +38 3.8000000000e-01 8.4561961580e+12 1.1815704470e+14 +39 3.9000000000e-01 7.3466977490e+12 1.0265420510e+14 +40 4.0000000000e-01 6.3827714970e+12 8.9185421350e+13 +41 4.1000000000e-01 5.5453175530e+12 7.7483814470e+13 +42 4.2000000000e-01 4.8177420700e+12 6.7317521340e+13 +43 4.3000000000e-01 4.1856284030e+12 5.8485100540e+13 +44 4.4000000000e-01 3.6364514480e+12 5.0811540850e+13 +45 4.5000000000e-01 3.1593294630e+12 4.4144793450e+13 +46 4.6000000000e-01 2.7448084480e+12 3.8352759160e+13 +47 4.7000000000e-01 2.3846748190e+12 3.3320670910e+13 +48 4.8000000000e-01 2.0717926600e+12 2.8948819710e+13 +49 4.9000000000e-01 1.7999623210e+12 2.5150578890e+13 +50 5.0000000000e-01 1.5637975860e+12 2.1850687690e+13 +51 5.1000000000e-01 1.3586189330e+12 1.8983759960e+13 +52 5.2000000000e-01 1.1803608230e+12 1.6492988570e+13 +53 5.3000000000e-01 1.0254911360e+12 1.4329019780e+13 +54 5.4000000000e-01 8.9094118400e+11 1.2448975330e+13 +55 5.5000000000e-01 7.7404490960e+11 1.0815602820e+13 +56 5.6000000000e-01 6.7248605500e+11 9.3965375690e+12 +57 5.7000000000e-01 5.8425226830e+11 8.1636613100e+12 +58 5.8000000000e-01 5.0759522880e+11 7.0925450460e+12 +59 5.9000000000e-01 4.4099600520e+11 6.1619649960e+12 +60 6.0000000000e-01 3.8313495790e+11 5.3534820520e+12 +61 6.1000000000e-01 3.3286559110e+11 4.6510764180e+12 +62 6.2000000000e-01 2.8919183550e+11 4.0408301810e+12 +63 6.3000000000e-01 2.5124831160e+11 3.5106515320e+12 +64 6.4000000000e-01 2.1828318200e+11 3.0500351720e+12 +65 6.5000000000e-01 1.8964325470e+11 2.6498541560e+12 +66 6.6000000000e-01 1.6476103990e+11 2.3021790410e+12 +67 6.7000000000e-01 1.4314350540e+11 2.0001207710e+12 +68 6.8000000000e-01 1.2436230780e+11 1.7376941700e+12 +69 6.9000000000e-01 1.0804530420e+11 1.5096993500e+12 +70 7.0000000000e-01 9.3869179290e+10 1.3116186770e+12 +71 7.1000000000e-01 8.1553038190e+10 1.1395272530e+12 +72 7.2000000000e-01 7.0852841020e+10 9.9001514990e+11 +73 7.3000000000e-01 6.1556567270e+10 8.6011983840e+11 +74 7.4000000000e-01 5.3480014620e+10 7.4726749030e+11 +75 7.5000000000e-01 4.6463149110e+10 6.4922197710e+11 +76 7.6000000000e-01 4.0366934090e+10 5.6404056250e+11 +77 7.7000000000e-01 3.5070575270e+10 4.9003540760e+11 +78 7.8000000000e-01 3.0469127200e+10 4.2574012690e+11 +79 7.9000000000e-01 2.6471413860e+10 3.6988073290e+11 +80 8.0000000000e-01 2.2998222010e+10 3.2135039170e+11 +81 8.1000000000e-01 1.9980731610e+10 2.7918749220e+11 +82 8.2000000000e-01 1.7359152180e+10 2.4255659190e+11 +83 8.3000000000e-01 1.5081538060e+10 2.1073186270e+11 +84 8.4000000000e-01 1.3102759170e+10 1.8308270910e+11 +85 8.5000000000e-01 1.1383606700e+10 1.5906127310e+11 +86 8.6000000000e-01 9.8900162880e+09 1.3819157870e+11 +87 8.7000000000e-01 8.5923929670e+09 1.2006010050e+11 +88 8.8000000000e-01 7.4650248040e+09 1.0430756970e+11 +89 8.9000000000e-01 6.4855734070e+09 9.0621855610e+10 +90 9.0000000000e-01 5.6346312990e+09 7.8731780830e+10 +91 9.1000000000e-01 4.8953373730e+09 6.8401747800e+10 +92 9.2000000000e-01 4.2530427840e+09 5.9427070660e+10 +93 9.3000000000e-01 3.6950207000e+09 5.1629919420e+10 +94 9.4000000000e-01 3.2102141140e+09 4.4855796350e+10 +95 9.5000000000e-01 2.7890167600e+09 3.8970474660e+10 +96 9.6000000000e-01 2.4230827630e+09 3.3857338820e+10 +97 9.7000000000e-01 2.1051612740e+09 2.9415073900e+10 +98 9.8000000000e-01 1.8289527940e+09 2.5555658020e+10 +99 9.9000000000e-01 1.5889843520e+09 2.2202618260e+10 +100 1.0000000000e+00 1.3805010610e+09 1.9289515350e+10 +101 1.0100000000e+00 1.1993718980e+09 1.6758627210e+10 +102 1.0200000000e+00 1.0420078550e+09 1.4559805200e+10 +103 1.0300000000e+00 9.0529082110e+08 1.2649480460e+10 +104 1.0400000000e+00 7.8651179720e+08 1.0989800600e+10 +105 1.0500000000e+00 6.8331721990e+08 9.5478796640e+09 +106 1.0600000000e+00 5.9366232610e+08 8.2951465080e+09 +107 1.0700000000e+00 5.1577063650e+08 7.2067786790e+09 +108 1.0800000000e+00 4.4809875540e+08 6.2612105610e+09 +109 1.0900000000e+00 3.8930578900e+08 5.4397060660e+09 +110 1.1000000000e+00 3.3822677600e+08 4.7259873780e+09 +111 1.1100000000e+00 2.9384960420e+08 4.1059124200e+09 +112 1.1200000000e+00 2.5529495590e+08 3.5671946310e+09 +113 1.1300000000e+00 2.2179888490e+08 3.0991595130e+09 +114 1.1400000000e+00 1.9269767840e+08 2.6925331190e+09 +115 1.1500000000e+00 1.6741470680e+08 2.3392582940e+09 +116 1.1600000000e+00 1.4544899700e+08 2.0323350270e+09 +117 1.1700000000e+00 1.2636530640e+08 1.7656817420e+09 +118 1.1800000000e+00 1.0978549870e+08 1.5340148030e+09 +119 1.1900000000e+00 9.5381050880e+07 1.3327438110e+09 +120 1.2000000000e+00 8.2866544090e+07 1.1578806560e+09 +121 1.2100000000e+00 7.1994007890e+07 1.0059604880e+09 +122 1.2200000000e+00 6.2548006910e+07 8.7397306220e+08 +123 1.2300000000e+00 5.4341372050e+07 7.5930309660e+08 +124 1.2400000000e+00 4.7211491810e+07 6.5967844720e+08 +125 1.2500000000e+00 4.1017090210e+07 5.7312508750e+08 +126 1.2600000000e+00 3.5635427400e+07 4.9792799400e+08 +127 1.2700000000e+00 3.0959867700e+07 4.3259716360e+08 +128 1.2800000000e+00 2.6897766570e+07 3.7583808940e+08 +129 1.2900000000e+00 2.3368634950e+07 3.2652611100e+08 +130 1.3000000000e+00 2.0302544380e+07 2.8368412930e+08 +131 1.3100000000e+00 1.7638741380e+07 2.4646324610e+08 +132 1.3200000000e+00 1.5324443660e+07 2.1412594280e+08 +133 1.3300000000e+00 1.3313794240e+07 1.8603146760e+08 +134 1.3400000000e+00 1.1566952840e+07 1.6162313870e+08 +135 1.3500000000e+00 1.0049306430e+07 1.4041731380e+08 +136 1.3600000000e+00 8.7307833840e+06 1.2199380710e+08 +137 1.3700000000e+00 7.5852576540e+06 1.0598756360e+08 +138 1.3800000000e+00 6.5900310600e+06 9.2081425300e+07 +139 1.3900000000e+00 5.7253835470e+06 7.9999847130e+07 +140 1.4000000000e+00 4.9741824370e+06 6.9503436980e+07 +141 1.4100000000e+00 4.3215429520e+06 6.0384212290e+07 +142 1.4200000000e+00 3.7545332780e+06 5.2461478920e+07 +143 1.4300000000e+00 3.2619183220e+06 4.5578250780e+07 +144 1.4400000000e+00 2.8339370970e+06 3.9598139180e+07 +145 1.4500000000e+00 2.4621093100e+06 3.4402650380e+07 +146 1.4600000000e+00 2.1390673290e+06 2.9888837650e+07 +147 1.4700000000e+00 1.8584101920e+06 2.5967261420e+07 +148 1.4800000000e+00 1.6145767810e+06 2.2560217080e+07 +149 1.4900000000e+00 1.4027356250e+06 1.9600195280e+07 +150 1.5000000000e+00 1.2186891680e+06 1.7028544260e+07 +151 1.5100000000e+00 1.0587905960e+06 1.4794307680e+07 +152 1.5200000000e+00 9.1987157580e+05 1.2853214960e+07 +153 1.5300000000e+00 7.9917947840e+05 1.1166804040e+07 +154 1.5400000000e+00 6.9432283320e+05 9.7016592970e+06 +155 1.5500000000e+00 6.0322394380e+05 8.4287494270e+06 +156 1.5600000000e+00 5.2407771850e+05 7.3228521760e+06 +157 1.5700000000e+00 4.5531590360e+05 6.3620545920e+06 +158 1.5800000000e+00 3.9557600860e+05 5.5273188170e+06 +159 1.5900000000e+00 3.4367430900e+05 4.8021048650e+06 +160 1.6000000000e+00 2.9858239160e+05 4.1720428830e+06 +161 1.6100000000e+00 2.5940677620e+05 3.6246484220e+06 +162 1.6200000000e+00 2.2537121220e+05 3.1490750570e+06 +163 1.6300000000e+00 1.9580129720e+05 2.7358994750e+06 +164 1.6400000000e+00 1.7011111410e+05 2.3769347520e+06 +165 1.6500000000e+00 1.4779162110e+05 2.0650681300e+06 +166 1.6600000000e+00 1.2840056570e+05 1.7941200870e+06 +167 1.6700000000e+00 1.1155372100e+05 1.5587218830e+06 +168 1.6800000000e+00 9.6917272910e+04 1.3542091900e+06 +169 1.6900000000e+00 8.4201205530e+04 1.1765296620e+06 +170 1.7000000000e+00 7.3153554570e+04 1.0221626440e+06 +171 1.7100000000e+00 6.3555414830e+04 8.8804940820e+05 +172 1.7200000000e+00 5.5216602630e+04 7.7153255030e+05 +173 1.7300000000e+00 4.7971887440e+04 6.7030333080e+05 +174 1.7400000000e+00 4.1677717830e+04 5.8235592920e+05 +175 1.7500000000e+00 3.6209377130e+04 5.0594769970e+05 +176 1.7600000000e+00 3.1458512140e+04 4.3956464070e+05 +177 1.7700000000e+00 2.7330986170e+04 3.8189139610e+05 +178 1.7800000000e+00 2.3745013820e+04 3.3178519130e+05 +179 1.7900000000e+00 2.0629540310e+04 2.8825319000e+05 +180 1.8000000000e+00 1.7922833690e+04 2.5043282140e+05 +181 1.8100000000e+00 1.5571261530e+04 2.1757468850e+05 +182 1.8200000000e+00 1.3528228280e+04 1.8902771940e+05 +183 1.8300000000e+00 1.1753251980e+04 1.6422626610e+05 +184 1.8400000000e+00 1.0211162120e+04 1.4267889680e+05 +185 1.8500000000e+00 8.8714027380e+03 1.2395865830e+05 +186 1.8600000000e+00 7.7074269920e+03 1.0769461580e+05 +187 1.8700000000e+00 6.6961711240e+03 9.3564503040e+04 +188 1.8800000000e+00 5.8175974640e+03 8.1288337100e+04 +189 1.8900000000e+00 5.0542973920e+03 7.0622870140e+04 +190 1.9000000000e+00 4.3911463950e+03 6.1356769800e+04 +191 1.9100000000e+00 3.8150043740e+03 5.3306431660e+04 +192 1.9200000000e+00 3.3144552850e+03 4.6312341170e+04 +193 1.9300000000e+00 2.8795809280e+03 4.0235912960e+04 +194 1.9400000000e+00 2.5017644250e+03 3.4956744810e+04 +195 1.9500000000e+00 2.1735194790e+03 3.0370231910e+04 +196 1.9600000000e+00 1.8883420360e+03 2.6385494170e+04 +197 1.9700000000e+00 1.6405814060e+03 2.2923575440e+04 +198 1.9800000000e+00 1.4253283030e+03 1.9915879070e+04 +199 1.9900000000e+00 1.2383175650e+03 1.7302808640e+04 +200 2.0000000000e+00 1.0758436410e+03 1.5032587100e+04 +201 2.0100000000e+00 9.3468717030e+02 1.3060230840e+04 +202 2.0200000000e+00 8.1205118730e+02 1.1346658320e+04 +203 2.0300000000e+00 7.0550570470e+02 9.8579157300e+03 +204 2.0400000000e+00 6.1293956240e+02 8.5645041750e+03 +205 2.0500000000e+00 5.3251859570e+02 7.4407951710e+03 +206 2.0600000000e+00 4.6264929230e+02 6.4645228320e+03 +207 2.0700000000e+00 4.0194721720e+02 5.6163426730e+03 +208 2.0800000000e+00 3.4920958090e+02 4.8794483120e+03 +209 2.0900000000e+00 3.0339140600e+02 4.2392384540e+03 +210 2.1000000000e+00 2.6358482200e+02 3.6830275730e+03 +211 2.1100000000e+00 2.2900107590e+02 3.1997945490e+03 +212 2.1200000000e+00 1.9895490330e+02 2.7799642980e+03 +213 2.1300000000e+00 1.7285095010e+02 2.4152180320e+03 +214 2.1400000000e+00 1.5017197590e+02 2.0983284390e+03 +215 2.1500000000e+00 1.3046860510e+02 1.8230164640e+03 +216 2.1600000000e+00 1.1335042260e+02 1.5838269000e+03 +217 2.1700000000e+00 9.8478237570e+01 1.3760202940e+03 +218 2.1800000000e+00 8.5557363230e+01 1.1954790320e+03 +219 2.1900000000e+00 7.4331777090e+01 1.0386257540e+03 +220 2.2000000000e+00 6.4579048210e+01 9.0235246990e+02 +221 2.2100000000e+00 5.6105929810e+01 7.8395897350e+02 +222 2.2200000000e+00 4.8744530110e+01 6.8109934040e+02 +223 2.2300000000e+00 4.2348985630e+01 5.9173544430e+02 +224 2.2400000000e+00 3.6792570990e+01 5.1409657190e+02 +225 2.2500000000e+00 3.1965187820e+01 4.4664433710e+02 +226 2.2600000000e+00 2.7771183280e+01 3.8804219830e+02 +227 2.2700000000e+00 2.4127454700e+01 3.3712897510e+02 +228 2.2800000000e+00 2.0961802900e+01 2.9289584070e+02 +229 2.2900000000e+00 1.8211501630e+01 2.5446633130e+02 +230 2.3000000000e+00 1.5822054690e+01 2.2107898030e+02 +231 2.3100000000e+00 1.3746116030e+01 1.9207222920e+02 +232 2.3200000000e+00 1.1942551680e+01 1.6687131990e+02 +233 2.3300000000e+00 1.0375624680e+01 1.4497690530e+02 +234 2.3400000000e+00 9.0142869290e+00 1.2595515570e+02 +235 2.3500000000e+00 7.8315640090e+00 1.0942916200e+02 +236 2.3600000000e+00 6.8040206970e+00 9.5071467470e+01 +237 2.3700000000e+00 5.9112965930e+00 8.2597579690e+01 +238 2.3800000000e+00 5.1357026910e+00 7.1760333060e+01 +239 2.3900000000e+00 4.4618708810e+00 6.2344991470e+01 +240 2.4000000000e+00 3.8764494280e+00 5.3036352210e+01 +241 2.4100000000e+00 3.3678384170e+00 4.8261295350e+01 +242 2.4200000000e+00 2.8941569300e+00 4.5857614440e+01 +243 2.4300000000e+00 2.4468631800e+00 4.3406963180e+01 +244 2.4400000000e+00 2.0256587860e+00 4.0812932280e+01 +245 2.4500000000e+00 1.6301260100e+00 3.8266641770e+01 +246 2.4600000000e+00 1.2597277660e+00 3.5780026500e+01 +247 2.4700000000e+00 9.1380761130e-01 3.3365021740e+01 +248 2.4800000000e+00 5.9158975140e-01 3.1033562180e+01 +249 2.4900000000e+00 2.9217903890e-01 2.8797954450e+01 +250 2.5000000000e+00 1.4560973470e-02 2.6671263930e+01 +251 2.5100000000e+00 -2.4238415820e-01 2.4661823870e+01 +252 2.5200000000e+00 -4.7981058030e-01 2.2768039630e+01 +253 2.5300000000e+00 -6.9883632600e-01 2.0983874620e+01 +254 2.5400000000e+00 -9.0052909770e-01 1.9303963110e+01 +255 2.5500000000e+00 -1.0859062660e+00 1.7723272100e+01 +256 2.5600000000e+00 -1.2559348720e+00 1.6236768280e+01 +257 2.5700000000e+00 -1.4115316230e+00 1.4839418560e+01 +258 2.5800000000e+00 -1.5535628980e+00 1.3526189880e+01 +259 2.5900000000e+00 -1.6828447430e+00 1.2292001960e+01 +260 2.6000000000e+00 -1.8001428730e+00 1.1131681390e+01 +261 2.6100000000e+00 -1.9061744430e+00 1.0040648660e+01 +262 2.6200000000e+00 -2.0016168960e+00 9.0155628370e+00 +263 2.6300000000e+00 -2.0871168150e+00 8.0536395060e+00 +264 2.6400000000e+00 -2.1632916940e+00 7.1520107860e+00 +265 2.6500000000e+00 -2.2307299330e+00 6.3077675390e+00 +266 2.6600000000e+00 -2.2899908440e+00 5.5180009250e+00 +267 2.6700000000e+00 -2.3416046480e+00 4.7798017190e+00 +268 2.6800000000e+00 -2.3860724750e+00 4.0902608440e+00 +269 2.6900000000e+00 -2.4238663650e+00 3.4464440960e+00 +270 2.7000000000e+00 -2.4554292680e+00 2.8453664940e+00 +271 2.7100000000e+00 -2.4811759890e+00 2.2843626470e+00 +272 2.7200000000e+00 -2.5014979300e+00 1.7614298710e+00 +273 2.7300000000e+00 -2.5167678200e+00 1.2748621430e+00 +274 2.7400000000e+00 -2.5273406710e+00 8.2290948110e-01 +275 2.7500000000e+00 -2.5335537710e+00 4.0379949770e-01 +276 2.7600000000e+00 -2.5357266870e+00 1.5760010280e-02 +277 2.7700000000e+00 -2.5341612640e+00 -3.4298090310e-01 +278 2.7800000000e+00 -2.5291416280e+00 -6.7419561340e-01 +279 2.7900000000e+00 -2.5209341800e+00 -9.7967404420e-01 +280 2.8000000000e+00 -2.5097876030e+00 -1.2612416950e+00 +281 2.8100000000e+00 -2.4959335160e+00 -1.5205003860e+00 +282 2.8200000000e+00 -2.4795897790e+00 -1.7585895080e+00 +283 2.8300000000e+00 -2.4609637910e+00 -1.9764437290e+00 +284 2.8400000000e+00 -2.4402531510e+00 -2.1750280650e+00 +285 2.8500000000e+00 -2.4176456570e+00 -2.3553224700e+00 +286 2.8600000000e+00 -2.3933193080e+00 -2.5183069580e+00 +287 2.8700000000e+00 -2.3674423020e+00 -2.6649614780e+00 +288 2.8800000000e+00 -2.3401730380e+00 -2.7962661310e+00 +289 2.8900000000e+00 -2.3116601130e+00 -2.9132049510e+00 +290 2.9000000000e+00 -2.2820423250e+00 -3.0167697150e+00 +291 2.9100000000e+00 -2.2514488140e+00 -3.1079034930e+00 +292 2.9200000000e+00 -2.2199997690e+00 -3.1874493890e+00 +293 2.9300000000e+00 -2.1878071410e+00 -3.2562082020e+00 +294 2.9400000000e+00 -2.1549747780e+00 -3.3149866360e+00 +295 2.9500000000e+00 -2.1215984330e+00 -3.3645944150e+00 +296 2.9600000000e+00 -2.0877657580e+00 -3.4058413510e+00 +297 2.9700000000e+00 -2.0535563080e+00 -3.4395371300e+00 +298 2.9800000000e+00 -2.0190415380e+00 -3.4664917760e+00 +299 2.9900000000e+00 -1.9842848030e+00 -3.4875215040e+00 +300 3.0000000000e+00 -1.9493413610e+00 -3.5034563820e+00 +301 3.0100000000e+00 -1.9142585830e+00 -3.5150471190e+00 +302 3.0200000000e+00 -1.8790770150e+00 -3.5228910160e+00 +303 3.0300000000e+00 -1.8438314390e+00 -3.5275214590e+00 +304 3.0400000000e+00 -1.8085510860e+00 -3.5289583340e+00 +305 3.0500000000e+00 -1.7732596360e+00 -3.5288908310e+00 +306 3.0600000000e+00 -1.7379752190e+00 -3.5280320940e+00 +307 3.0700000000e+00 -1.7027104110e+00 -3.5253862790e+00 +308 3.0800000000e+00 -1.6674722390e+00 -3.5223395310e+00 +309 3.0900000000e+00 -1.6322621780e+00 -3.5194378970e+00 +310 3.1000000000e+00 -1.5970761530e+00 -3.5173081740e+00 +311 3.1100000000e+00 -1.5619051030e+00 -3.5168447480e+00 +312 3.1200000000e+00 -1.5267378260e+00 -3.5168563320e+00 +313 3.1300000000e+00 -1.4915638140e+00 -3.5177518380e+00 +314 3.1400000000e+00 -1.4563738200e+00 -3.5198200760e+00 +315 3.1500000000e+00 -1.4211598630e+00 -3.5226190880e+00 +316 3.1600000000e+00 -1.3859152220e+00 -3.5260255420e+00 +317 3.1700000000e+00 -1.3506344420e+00 -3.5299136690e+00 +318 3.1800000000e+00 -1.3153133290e+00 -3.5341578930e+00 +319 3.1900000000e+00 -1.2799489510e+00 -3.5386343920e+00 +320 3.2000000000e+00 -1.2445396420e+00 -3.5432253600e+00 +321 3.2100000000e+00 -1.2090851000e+00 -3.5477800910e+00 +322 3.2200000000e+00 -1.1735869120e+00 -3.5520723480e+00 +323 3.2300000000e+00 -1.1380490760e+00 -3.5558443110e+00 +324 3.2400000000e+00 -1.1024780970e+00 -3.5588459720e+00 +325 3.2500000000e+00 -1.0668829990e+00 -3.5606965620e+00 +326 3.2600000000e+00 -1.0312753150e+00 -3.5607083610e+00 +327 3.2700000000e+00 -9.9566909100e-01 -3.5605541570e+00 +328 3.2800000000e+00 -9.6008088680e-01 -3.5579489480e+00 +329 3.2900000000e+00 -9.2452977440e-01 -3.5533045150e+00 +330 3.3000000000e+00 -8.8903733850e-01 -3.5464131370e+00 +331 3.3100000000e+00 -8.5362827280e-01 -3.5368973480e+00 +332 3.3200000000e+00 -8.1833336060e-01 -3.5239572210e+00 +333 3.3300000000e+00 -7.8319245590e-01 -3.5065687200e+00 +334 3.3400000000e+00 -7.4825507930e-01 -3.4837450990e+00 +335 3.3500000000e+00 -7.1358041810e-01 -3.4545190770e+00 +336 3.3600000000e+00 -6.7923732650e-01 -3.4179238010e+00 +337 3.3700000000e+00 -6.4530432520e-01 -3.3729926040e+00 +338 3.3800000000e+00 -6.1186960170e-01 -3.3187588290e+00 +339 3.3900000000e+00 -5.7903101040e-01 -3.2542297980e+00 +340 3.4000000000e+00 -5.4689607220e-01 -3.1783580730e+00 +341 3.4100000000e+00 -5.1558072820e-01 -3.0904661310e+00 +342 3.4200000000e+00 -4.8520310790e-01 -2.9907576290e+00 +343 3.4300000000e+00 -4.5587729660e-01 -2.8798705460e+00 +344 3.4400000000e+00 -4.2771208900e-01 -2.7583688810e+00 +345 3.4500000000e+00 -4.0081098950e-01 -2.6267815840e+00 +346 3.4600000000e+00 -3.7527221170e-01 -2.4856376550e+00 +347 3.4700000000e+00 -3.5118867890e-01 -2.3354660560e+00 +348 3.4800000000e+00 -3.2864802400e-01 -2.1767958410e+00 +349 3.4900000000e+00 -3.0773258900e-01 -2.0101012320e+00 +350 3.5000000000e+00 -2.8851942590e-01 -1.8357436110e+00 +351 3.5100000000e+00 -2.7107800890e-01 -1.6548080920e+00 +352 3.5200000000e+00 -2.5545880110e-01 -1.4699936560e+00 +353 3.5300000000e+00 -2.4168181970e-01 -1.2847553720e+00 +354 3.5400000000e+00 -2.2973434990e-01 -1.1024244830e+00 +355 3.5500000000e+00 -2.1957094400e-01 -9.2627328940e-01 +356 3.5600000000e+00 -2.1111342220e-01 -7.5957368970e-01 +357 3.5700000000e+00 -2.0425087220e-01 -6.0559684560e-01 +358 3.5800000000e+00 -1.9883964940e-01 -4.6761229440e-01 +359 3.5900000000e+00 -1.9470337660e-01 -3.4905079620e-01 +360 3.6000000000e+00 -1.9163294430e-01 -2.5373424880e-01 +361 3.6100000000e+00 -1.8939187810e-01 -1.8353921730e-01 +362 3.6200000000e+00 -1.8774317600e-01 -1.3643213030e-01 +363 3.6300000000e+00 -1.8647614590e-01 -1.0900277830e-01 +364 3.6400000000e+00 -1.8541177300e-01 -1.0217451770e-01 +365 3.6500000000e+00 -1.8440272000e-01 -1.0257729120e-01 +366 3.6600000000e+00 -1.8333332690e-01 -1.1032823210e-01 +367 3.6700000000e+00 -1.8211961100e-01 -1.2921992570e-01 +368 3.6800000000e+00 -1.8070926700e-01 -1.5163890710e-01 +369 3.6900000000e+00 -1.7908166700e-01 -1.7442524050e-01 +370 3.7000000000e+00 -1.7724786040e-01 -1.9407009560e-01 +371 3.7100000000e+00 -1.7524726610e-01 -2.0823224750e-01 +372 3.7200000000e+00 -1.7313113340e-01 -2.1707301960e-01 +373 3.7300000000e+00 -1.7094600210e-01 -2.2155931460e-01 +374 3.7400000000e+00 -1.6873039540e-01 -2.2155890460e-01 +375 3.7500000000e+00 -1.6651481940e-01 -2.2155573260e-01 +376 3.7600000000e+00 -1.6432176310e-01 -2.1804279820e-01 +377 3.7700000000e+00 -1.6216569890e-01 -2.1356882610e-01 +378 3.7800000000e+00 -1.6005308190e-01 -2.0885944940e-01 +379 3.7900000000e+00 -1.5798235030e-01 -2.0472213750e-01 +380 3.8000000000e+00 -1.5594392560e-01 -2.0241705720e-01 +381 3.8100000000e+00 -1.5392117290e-01 -2.0241827750e-01 +382 3.8200000000e+00 -1.5189520660e-01 -2.0277318370e-01 +383 3.8300000000e+00 -1.4984969490e-01 -2.0558456320e-01 +384 3.8400000000e+00 -1.4777182060e-01 -2.0947681570e-01 +385 3.8500000000e+00 -1.4565228170e-01 -2.1411724290e-01 +386 3.8600000000e+00 -1.4348529090e-01 -2.1915859900e-01 +387 3.8700000000e+00 -1.4126857580e-01 -2.2425124170e-01 +388 3.8800000000e+00 -1.3900337870e-01 -2.2904532330e-01 +389 3.8900000000e+00 -1.3669445690e-01 -2.3317711800e-01 +390 3.9000000000e+00 -1.3435008260e-01 -2.3624008380e-01 +391 3.9100000000e+00 -1.3198159090e-01 -2.3798596650e-01 +392 3.9200000000e+00 -1.2960112040e-01 -2.3812682950e-01 +393 3.9300000000e+00 -1.2721935400e-01 -2.3811467960e-01 +394 3.9400000000e+00 -1.2484506660e-01 -2.3702815340e-01 +395 3.9500000000e+00 -1.2248512560e-01 -2.3523949930e-01 +396 3.9600000000e+00 -1.2014449050e-01 -2.3305519030e-01 +397 3.9700000000e+00 -1.1782621320e-01 -2.3066255720e-01 +398 3.9800000000e+00 -1.1553143760e-01 -2.2825101140e-01 +399 3.9900000000e+00 -1.1325940020e-01 -2.2601755080e-01 +400 4.0000000000e+00 -1.1100742940e-01 -2.2417862310e-01 +401 4.0100000000e+00 -1.0877118630e-01 -2.2286349760e-01 +402 4.0200000000e+00 -1.0654586480e-01 -2.2202230410e-01 +403 4.0300000000e+00 -1.0432739300e-01 -2.2154405680e-01 +404 4.0400000000e+00 -1.0211267260e-01 -2.2132766590e-01 +405 4.0500000000e+00 -9.9899579570e-02 -2.2126903570e-01 +406 4.0600000000e+00 -9.7686963680e-02 -2.2125247670e-01 +407 4.0700000000e+00 -9.5474648740e-02 -2.2122106790e-01 +408 4.0800000000e+00 -9.3263432500e-02 -2.2107465710e-01 +409 4.0900000000e+00 -9.1055086710e-02 -2.2070112830e-01 +410 4.1000000000e+00 -8.8852357090e-02 -2.1999541830e-01 +411 4.1100000000e+00 -8.6658837090e-02 -2.1888407060e-01 +412 4.1200000000e+00 -8.4478336830e-02 -2.1738813900e-01 +413 4.1300000000e+00 -8.2314251940e-02 -2.1557604180e-01 +414 4.1400000000e+00 -8.0169437390e-02 -2.1350571680e-01 +415 4.1500000000e+00 -7.8046207450e-02 -2.1123112730e-01 +416 4.1600000000e+00 -7.5946335690e-02 -2.0880628380e-01 +417 4.1700000000e+00 -7.3871055030e-02 -2.0628522250e-01 +418 4.1800000000e+00 -7.1821057660e-02 -2.0372199140e-01 +419 4.1900000000e+00 -6.9796495110e-02 -2.0117226580e-01 +420 4.2000000000e+00 -6.7796978220e-02 -1.9869515570e-01 +421 4.2100000000e+00 -6.5821640000e-02 -1.9632881020e-01 +422 4.2200000000e+00 -6.3869449890e-02 -1.9406713000e-01 +423 4.2300000000e+00 -6.1939528000e-02 -1.9188425280e-01 +424 4.2400000000e+00 -6.0031208040e-02 -1.8975732620e-01 +425 4.2500000000e+00 -5.8144037210e-02 -1.8766499860e-01 +426 4.2600000000e+00 -5.6277776300e-02 -1.8558591260e-01 +427 4.2700000000e+00 -5.4432399640e-02 -1.8349871850e-01 +428 4.2800000000e+00 -5.2608095090e-02 -1.8138206230e-01 +429 4.2900000000e+00 -5.0805264080e-02 -1.7921412530e-01 +430 4.3000000000e+00 -4.9024521580e-02 -1.7697218360e-01 +431 4.3100000000e+00 -4.7266676850e-02 -1.7463962540e-01 +432 4.3200000000e+00 -4.5532637180e-02 -1.7221329340e-01 +433 4.3300000000e+00 -4.3823311560e-02 -1.6969643540e-01 +434 4.3400000000e+00 -4.2139591520e-02 -1.6709130180e-01 +435 4.3500000000e+00 -4.0482351020e-02 -1.6439964880e-01 +436 4.3600000000e+00 -3.8852446520e-02 -1.6162322490e-01 +437 4.3700000000e+00 -3.7250716970e-02 -1.5876378180e-01 +438 4.3800000000e+00 -3.5677983800e-02 -1.5582307140e-01 +439 4.3900000000e+00 -3.4135050920e-02 -1.5280279030e-01 +440 4.4000000000e+00 -3.2622704710e-02 -1.4970451960e-01 +441 4.4100000000e+00 -3.1141711720e-02 -1.4653058420e-01 +442 4.4200000000e+00 -2.9692807030e-02 -1.4328494170e-01 +443 4.4300000000e+00 -2.8276682610e-02 -1.3997231400e-01 +444 4.4400000000e+00 -2.6893985010e-02 -1.3659730260e-01 +445 4.4500000000e+00 -2.5545315350e-02 -1.3316445100e-01 +446 4.4600000000e+00 -2.4231229320e-02 -1.2967830180e-01 +447 4.4700000000e+00 -2.2952237190e-02 -1.2614339590e-01 +448 4.4800000000e+00 -2.1708803810e-02 -1.2256427830e-01 +449 4.4900000000e+00 -2.0501348580e-02 -1.1894531750e-01 +450 4.5000000000e+00 -1.9330245510e-02 -1.1529053780e-01 +451 4.5100000000e+00 -1.8195816190e-02 -1.1160621010e-01 +452 4.5200000000e+00 -1.7098295100e-02 -1.0790348070e-01 +453 4.5300000000e+00 -1.6037794770e-02 -1.0419576570e-01 +454 4.5400000000e+00 -1.5014298890e-02 -1.0049612610e-01 +455 4.5500000000e+00 -1.4027662260e-02 -9.6817447880e-02 +456 4.5600000000e+00 -1.3077610840e-02 -9.3172619330e-02 +457 4.5700000000e+00 -1.2163741680e-02 -8.9574526510e-02 +458 4.5800000000e+00 -1.1285523010e-02 -8.6036054070e-02 +459 4.5900000000e+00 -1.0442294160e-02 -8.2570683340e-02 +460 4.6000000000e+00 -9.6332655980e-03 -7.9193083800e-02 +461 4.6100000000e+00 -8.8575419760e-03 -7.5910311180e-02 +462 4.6200000000e+00 -8.1142373740e-03 -7.2713282330e-02 +463 4.6300000000e+00 -7.4025905500e-03 -6.9585550720e-02 +464 4.6400000000e+00 -6.7219879870e-03 -6.6511783650e-02 +465 4.6500000000e+00 -6.0719638950e-03 -6.3477208480e-02 +466 4.6600000000e+00 -5.4522002110e-03 -6.0467053010e-02 +467 4.6700000000e+00 -4.8625265960e-03 -5.7466544920e-02 +468 4.6800000000e+00 -4.3029204390e-03 -5.4460911670e-02 +469 4.6900000000e+00 -3.7735068550e-03 -5.1434523580e-02 +470 4.7000000000e+00 -3.2745586850e-03 -4.8370043780e-02 +471 4.7100000000e+00 -2.8064617420e-03 -4.5261307720e-02 +472 4.7200000000e+00 -2.3695410370e-03 -4.2126515780e-02 +473 4.7300000000e+00 -1.9638870030e-03 -3.8995268370e-02 +474 4.7400000000e+00 -1.5893207430e-03 -3.5895375370e-02 +475 4.7500000000e+00 -1.2453940290e-03 -3.2853768170e-02 +476 4.7600000000e+00 -9.3138930210e-04 -2.9897377850e-02 +477 4.7700000000e+00 -6.4631967200e-04 -2.7053134890e-02 +478 4.7800000000e+00 -3.8892891730e-04 -2.4347968780e-02 +479 4.7900000000e+00 -1.5769148580e-04 -2.1809973910e-02 +480 4.8000000000e+00 4.9187505960e-05 -1.9469671160e-02 +481 4.8100000000e+00 2.3372925440e-04 -1.7342891530e-02 +482 4.8200000000e+00 3.9796617840e-04 -1.5415189150e-02 +483 4.8300000000e+00 5.4372682880e-04 -1.3658952380e-02 +484 4.8400000000e+00 6.7259287050e-04 -1.2048522610e-02 +485 4.8500000000e+00 7.8589908240e-04 -1.0559209690e-02 +486 4.8600000000e+00 8.8473335710e-04 -9.1663247630e-03 +487 4.8700000000e+00 9.6993670140e-04 -7.8451808230e-03 +488 4.8800000000e+00 1.0421032360e-03 -6.5710929150e-03 +489 4.8900000000e+00 1.1015801950e-03 -5.3185837070e-03 +490 4.9000000000e+00 1.1484679270e-03 -4.0606536610e-03 +491 4.9100000000e+00 1.1826519980e-03 -2.7805919490e-03 +492 4.9200000000e+00 1.2039636980e-03 -1.4840911740e-03 +493 4.9300000000e+00 1.2123405590e-03 -1.8744637850e-04 +494 4.9400000000e+00 1.2078584520e-03 1.0946955090e-03 +495 4.9500000000e+00 1.1907315900e-03 2.3485018540e-03 +496 4.9600000000e+00 1.1613125250e-03 3.5601402240e-03 +497 4.9700000000e+00 1.1200921520e-03 4.7157788300e-03 +498 4.9800000000e+00 1.0676997050e-03 5.8015868510e-03 +499 4.9900000000e+00 1.0049027610e-03 6.8031822230e-03 +500 5.0000000000e+00 9.3260723520e-04 7.7050078140e-03 +501 5.0100000000e+00 8.5183745480e-04 8.4983969340e-03 +502 5.0200000000e+00 7.6363650240e-04 9.1887805930e-03 +503 5.0300000000e+00 6.6896656300e-04 9.7875612980e-03 +504 5.0400000000e+00 5.6868899310e-04 1.0305252310e-02 +505 5.0500000000e+00 4.6356432080e-04 1.0751939230e-02 +506 5.0600000000e+00 3.5425224560e-04 1.1137708580e-02 +507 5.0700000000e+00 2.4131163850e-04 1.1472647570e-02 +508 5.0800000000e+00 1.2520054220e-04 1.1766843320e-02 +509 5.0900000000e+00 6.2761706890e-06 1.2030583530e-02 +510 5.1000000000e+00 -1.1520509050e-04 1.2274519120e-02 +511 5.1100000000e+00 -2.3908004220e-04 1.2506742270e-02 +512 5.1200000000e+00 -3.6524046290e-04 1.2730078350e-02 +513 5.1300000000e+00 -4.9359489830e-04 1.2944907750e-02 +514 5.1400000000e+00 -6.2406102030e-04 1.3151960710e-02 +515 5.1500000000e+00 -7.5656562640e-04 1.3352149800e-02 +516 5.1600000000e+00 -8.9104464010e-04 1.3546387640e-02 +517 5.1700000000e+00 -1.0274431110e-03 1.3735586810e-02 +518 5.1800000000e+00 -1.1657152140e-03 1.3920659690e-02 +519 5.1900000000e+00 -1.3058242490e-03 1.4102349940e-02 +520 5.2000000000e+00 -1.4477426450e-03 1.4281081480e-02 +521 5.2100000000e+00 -1.5914586660e-03 1.4459496790e-02 +522 5.2200000000e+00 -1.7370099740e-03 1.4644838790e-02 +523 5.2300000000e+00 -1.8845171920e-03 1.4846534220e-02 +524 5.2400000000e+00 -2.0341906130e-03 1.5073718280e-02 +525 5.2500000000e+00 -2.1863302000e-03 1.5335361050e-02 +526 5.2600000000e+00 -2.3413255880e-03 1.5640434670e-02 +527 5.2700000000e+00 -2.4996560810e-03 1.5997911230e-02 +528 5.2800000000e+00 -2.6618906560e-03 1.6416762160e-02 +529 5.2900000000e+00 -2.8286879610e-03 1.6906373970e-02 +530 5.3000000000e+00 -3.0007963120e-03 1.7477007110e-02 +531 5.3100000000e+00 -3.1790339990e-03 1.8133074970e-02 +532 5.3200000000e+00 -3.3641907710e-03 1.8865012170e-02 +533 5.3300000000e+00 -3.5569293410e-03 1.9656413040e-02 +534 5.3400000000e+00 -3.7577656750e-03 2.0492060870e-02 +535 5.3500000000e+00 -3.9670690000e-03 2.1357287210e-02 +536 5.3600000000e+00 -4.1850618000e-03 2.2237421170e-02 +537 5.3700000000e+00 -4.4118198130e-03 2.3117792040e-02 +538 5.3800000000e+00 -4.6472720400e-03 2.3983729020e-02 +539 5.3900000000e+00 -4.8912007360e-03 2.4820173120e-02 +540 5.4000000000e+00 -5.1432414150e-03 2.5611246230e-02 +541 5.4100000000e+00 -5.4028974590e-03 2.6345995690e-02 +542 5.4200000000e+00 -5.6696131800e-03 2.7023783330e-02 +543 5.4300000000e+00 -5.9428468820e-03 2.7648494840e-02 +544 5.4400000000e+00 -6.2220854650e-03 2.8223326690e-02 +545 5.4500000000e+00 -6.5068444350e-03 2.8751139070e-02 +546 5.4600000000e+00 -6.7966678950e-03 2.9234792020e-02 +547 5.4700000000e+00 -7.0911285520e-03 2.9677145900e-02 +548 5.4800000000e+00 -7.3898277130e-03 3.0081060730e-02 +549 5.4900000000e+00 -7.6923952860e-03 3.0449630790e-02 +550 5.5000000000e+00 -7.9984897810e-03 3.0786428800e-02 +551 5.5100000000e+00 -8.3077897170e-03 3.1092132900e-02 +552 5.5200000000e+00 -8.6199506760e-03 3.1361354280e-02 +553 5.5300000000e+00 -8.9345623430e-03 3.1586068180e-02 +554 5.5400000000e+00 -9.2511399250e-03 3.1758727190e-02 +555 5.5500000000e+00 -9.5691241460e-03 3.1872314690e-02 +556 5.5600000000e+00 -9.8878812460e-03 3.1879060490e-02 +557 5.5700000000e+00 -1.0206702980e-02 3.1879343290e-02 +558 5.5800000000e+00 -1.0524806640e-02 3.1775291070e-02 +559 5.5900000000e+00 -1.0841335000e-02 3.1575078260e-02 +560 5.6000000000e+00 -1.1155356390e-02 3.1277094940e-02 +561 5.6100000000e+00 -1.1465874190e-02 3.0876002420e-02 +562 5.6200000000e+00 -1.1771874720e-02 3.0373359010e-02 +563 5.6300000000e+00 -1.2072375040e-02 2.9774158060e-02 +564 5.6400000000e+00 -1.2366432510e-02 2.9082718780e-02 +565 5.6500000000e+00 -1.2653144820e-02 2.8303067980e-02 +566 5.6600000000e+00 -1.2931649940e-02 2.7439235100e-02 +567 5.6700000000e+00 -1.3201126190e-02 2.6495251650e-02 +568 5.6800000000e+00 -1.3460792170e-02 2.5475145970e-02 +569 5.6900000000e+00 -1.3709906810e-02 2.4382869130e-02 +570 5.7000000000e+00 -1.3947769340e-02 2.3222203640e-02 +571 5.7100000000e+00 -1.4173722750e-02 2.1998018300e-02 +572 5.7200000000e+00 -1.4387171000e-02 2.0717601730e-02 +573 5.7300000000e+00 -1.4587596210e-02 1.9389388150e-02 +574 5.7400000000e+00 -1.4774562110e-02 1.8021631230e-02 +575 5.7500000000e+00 -1.4947714070e-02 1.6622492240e-02 +576 5.7600000000e+00 -1.5106779050e-02 1.5200129840e-02 +577 5.7700000000e+00 -1.5251565630e-02 1.3762707810e-02 +578 5.7800000000e+00 -1.5381964020e-02 1.2318387210e-02 +579 5.7900000000e+00 -1.5497946030e-02 1.0875476430e-02 +580 5.8000000000e+00 -1.5599565090e-02 9.4425870750e-03 +581 5.8100000000e+00 -1.5686950370e-02 8.0264086870e-03 +582 5.8200000000e+00 -1.5760277400e-02 6.6295090340e-03 +583 5.8300000000e+00 -1.5819738700e-02 5.2525609880e-03 +584 5.8400000000e+00 -1.5865537890e-02 3.8965319600e-03 +585 5.8500000000e+00 -1.5897889720e-02 2.5625313690e-03 +586 5.8600000000e+00 -1.5917020020e-02 1.2516718340e-03 +587 5.8700000000e+00 -1.5923165770e-02 -3.4937058100e-05 +588 5.8800000000e+00 -1.5916575010e-02 -1.2961843800e-03 +589 5.8900000000e+00 -1.5897506940e-02 -2.5310939070e-03 +590 5.9000000000e+00 -1.5866231840e-02 -3.7389705170e-03 +591 5.9100000000e+00 -1.5823036470e-02 -4.9173578470e-03 +592 5.9200000000e+00 -1.5768250830e-02 -6.0600357120e-03 +593 5.9300000000e+00 -1.5702275000e-02 -7.1590688840e-03 +594 5.9400000000e+00 -1.5625584430e-02 -8.2067883000e-03 +595 5.9500000000e+00 -1.5538730000e-02 -9.1956535530e-03 +596 5.9600000000e+00 -1.5442337980e-02 -1.0118124370e-02 +597 5.9700000000e+00 -1.5337110070e-02 -1.0966662250e-02 +598 5.9800000000e+00 -1.5223823350e-02 -1.1733731860e-02 +599 5.9900000000e+00 -1.5103330310e-02 -1.2411346770e-02 +600 6.0000000000e+00 -1.4976558850e-02 -1.2990539800e-02 +601 6.0100000000e+00 -1.4844496760e-02 -1.3467852250e-02 +602 6.0200000000e+00 -1.4708114030e-02 -1.3850882370e-02 +603 6.0300000000e+00 -1.4568285260e-02 -1.4151686870e-02 +604 6.0400000000e+00 -1.4425774100e-02 -1.4381668920e-02 +605 6.0500000000e+00 -1.4281233220e-02 -1.4551925990e-02 +606 6.0600000000e+00 -1.4135204390e-02 -1.4673570400e-02 +607 6.0700000000e+00 -1.3988118420e-02 -1.4757756220e-02 +608 6.0800000000e+00 -1.3840295150e-02 -1.4815688990e-02 +609 6.0900000000e+00 -1.3691943500e-02 -1.4859029650e-02 +610 6.1000000000e+00 -1.3543161430e-02 -1.4899772950e-02 +611 6.1100000000e+00 -1.3393954760e-02 -1.4944650430e-02 +612 6.1200000000e+00 -1.3244331080e-02 -1.4987875210e-02 +613 6.1300000000e+00 -1.3094393730e-02 -1.4999195980e-02 +614 6.1400000000e+00 -1.2944360580e-02 -1.5000406620e-02 +615 6.1500000000e+00 -1.2794564020e-02 -1.4968741120e-02 +616 6.1600000000e+00 -1.2645450970e-02 -1.4878631960e-02 +617 6.1700000000e+00 -1.2497582900e-02 -1.4726360280e-02 +618 6.1800000000e+00 -1.2351635780e-02 -1.4500650680e-02 +619 6.1900000000e+00 -1.2208400130e-02 -1.4189602640e-02 +620 6.2000000000e+00 -1.2068780980e-02 -1.3780088450e-02 +621 6.2100000000e+00 -1.1933770350e-02 -1.3266656360e-02 +622 6.2200000000e+00 -1.1804309490e-02 -1.2663757970e-02 +623 6.2300000000e+00 -1.1681151160e-02 -1.1995648740e-02 +624 6.2400000000e+00 -1.1564832050e-02 -1.1284711830e-02 +625 6.2500000000e+00 -1.1455672780e-02 -1.0552530900e-02 +626 6.2600000000e+00 -1.1353777930e-02 -9.8206944580e-03 +627 6.2700000000e+00 -1.1259036020e-02 -9.1107917220e-03 +628 6.2800000000e+00 -1.1171119520e-02 -8.4444087170e-03 +629 6.2900000000e+00 -1.1089484820e-02 -7.8440382630e-03 +630 6.3000000000e+00 -1.1013372280e-02 -7.3343059900e-03 +631 6.3100000000e+00 -1.0941837570e-02 -6.9286062890e-03 +632 6.3200000000e+00 -1.0873908590e-02 -6.6177004520e-03 +633 6.3300000000e+00 -1.0808742380e-02 -6.3836149380e-03 +634 6.3400000000e+00 -1.0745656480e-02 -6.2096675710e-03 +635 6.3500000000e+00 -1.0684128980e-02 -6.0797276050e-03 +636 6.3600000000e+00 -1.0623798440e-02 -5.9776679450e-03 +637 6.3700000000e+00 -1.0564463980e-02 -5.8875005540e-03 +638 6.3800000000e+00 -1.0506085210e-02 -5.7934100960e-03 +639 6.3900000000e+00 -1.0448782260e-02 -5.6790958870e-03 +640 6.4000000000e+00 -1.0392835790e-02 -5.5272351870e-03 +641 6.4100000000e+00 -1.0338663800e-02 -5.3265489450e-03 +642 6.4200000000e+00 -1.0286705990e-02 -5.0824779890e-03 +643 6.4300000000e+00 -1.0237307970e-02 -4.8090647670e-03 +644 6.4400000000e+00 -1.0190698140e-02 -4.5186980020e-03 +645 6.4500000000e+00 -1.0146987700e-02 -4.2230772190e-03 +646 6.4600000000e+00 -1.0106170660e-02 -3.9339072730e-03 +647 6.4700000000e+00 -1.0068123810e-02 -3.6628907880e-03 +648 6.4800000000e+00 -1.0032606730e-02 -3.4217128560e-03 +649 6.4900000000e+00 -9.9992617940e-03 -3.2226936060e-03 +650 6.5000000000e+00 -9.9676141880e-03 -3.0800614930e-03 +651 6.5100000000e+00 -9.9370921530e-03 -3.0007974900e-03 +652 6.5200000000e+00 -9.9071283790e-03 -2.9895971810e-03 +653 6.5300000000e+00 -9.8772613860e-03 -2.9909390270e-03 +654 6.5400000000e+00 -9.8471557910e-03 -3.0244442110e-03 +655 6.5500000000e+00 -9.8166023160e-03 -3.0807584720e-03 +656 6.5600000000e+00 -9.7855177830e-03 -3.1389446580e-03 +657 6.5700000000e+00 -9.7539451160e-03 -3.1876831780e-03 +658 6.5800000000e+00 -9.7220533400e-03 -3.1902459520e-03 +659 6.5900000000e+00 -9.6901375810e-03 -3.1905666810e-03 +660 6.6000000000e+00 -9.6586190680e-03 -3.1317577790e-03 +661 6.6100000000e+00 -9.6280205840e-03 -3.0113946400e-03 +662 6.6200000000e+00 -9.5988437380e-03 -2.8430708940e-03 +663 6.6300000000e+00 -9.5714462370e-03 -2.6468063050e-03 +664 6.6400000000e+00 -9.5460173390e-03 -2.4401082740e-03 +665 6.6500000000e+00 -9.5225778510e-03 -2.2397114760e-03 +666 6.6600000000e+00 -9.5009801320e-03 -2.0623027660e-03 +667 6.6700000000e+00 -9.4809080910e-03 -1.9242058160e-03 +668 6.6800000000e+00 -9.4618771900e-03 -1.8756816070e-03 +669 6.6900000000e+00 -9.4432344390e-03 -1.8737538630e-03 +670 6.7000000000e+00 -9.4241584000e-03 -1.9296967320e-03 +671 6.7100000000e+00 -9.4036962210e-03 -2.1193480020e-03 +672 6.7200000000e+00 -9.3809488110e-03 -2.3946186600e-03 +673 6.7300000000e+00 -9.3552560140e-03 -2.7229160010e-03 +674 6.7400000000e+00 -9.3262336490e-03 -3.0756765770e-03 +675 6.7500000000e+00 -9.2937735010e-03 -3.4254765850e-03 +676 6.7600000000e+00 -9.2580433320e-03 -3.7449102950e-03 +677 6.7700000000e+00 -9.2194868700e-03 -4.0068658770e-03 +678 6.7800000000e+00 -9.1788238190e-03 -4.1695216600e-03 +679 6.7900000000e+00 -9.1370498500e-03 -4.1709417970e-03 +680 6.8000000000e+00 -9.0954366100e-03 -4.1531823070e-03 +681 6.8100000000e+00 -9.0554785850e-03 -3.9087191710e-03 +682 6.8200000000e+00 -9.0186274690e-03 -3.5228649830e-03 +683 6.8300000000e+00 -8.9860265190e-03 -3.0396673600e-03 +684 6.8400000000e+00 -8.9584574300e-03 -2.4966871920e-03 +685 6.8500000000e+00 -8.9363403360e-03 -1.9298633360e-03 +686 6.8600000000e+00 -8.9197338070e-03 -1.3752156630e-03 +687 6.8700000000e+00 -8.9083348510e-03 -8.6872626790e-04 +688 6.8800000000e+00 -8.9014789130e-03 -4.4613382030e-04 +689 6.8900000000e+00 -8.8981398760e-03 -1.4464164490e-04 +690 6.9000000000e+00 -8.8969300610e-03 -9.3306974460e-05 +691 6.9100000000e+00 -8.8961599030e-03 -9.4842573110e-05 +692 6.9200000000e+00 -8.8941363350e-03 -2.6951752300e-04 +693 6.9300000000e+00 -8.8894611720e-03 -6.0677709890e-04 +694 6.9400000000e+00 -8.8810907890e-03 -1.0295850060e-03 +695 6.9500000000e+00 -8.8683361180e-03 -1.5032386040e-03 +696 6.9600000000e+00 -8.8508626520e-03 -1.9925371240e-03 +697 6.9700000000e+00 -8.8286904430e-03 -2.4622017850e-03 +698 6.9800000000e+00 -8.8021941000e-03 -2.8770558440e-03 +699 6.9900000000e+00 -8.7721027940e-03 -3.2001665000e-03 +700 7.0000000000e+00 -8.7395002530e-03 -3.3628110830e-03 +701 7.0100000000e+00 -8.7057669680e-03 -3.3616587300e-03 +702 7.0200000000e+00 -8.6722912150e-03 -3.3328724970e-03 +703 7.0300000000e+00 -8.6401800780e-03 -3.1369921780e-03 +704 7.0400000000e+00 -8.6102016490e-03 -2.8836524560e-03 +705 7.0500000000e+00 -8.5827850310e-03 -2.6048254500e-03 +706 7.0600000000e+00 -8.5580203390e-03 -2.3338108210e-03 +707 7.0700000000e+00 -8.5356586960e-03 -2.1036368350e-03 +708 7.0800000000e+00 -8.5151122380e-03 -1.9811072220e-03 +709 7.0900000000e+00 -8.4954541080e-03 -1.9777398690e-03 +710 7.1000000000e+00 -8.4754184640e-03 -2.0225113290e-03 +711 7.1100000000e+00 -8.4534593770e-03 -2.2965828040e-03 +712 7.1200000000e+00 -8.4280453800e-03 -2.7212170120e-03 +713 7.1300000000e+00 -8.3979540000e-03 -3.2510514740e-03 +714 7.1400000000e+00 -8.3623306660e-03 -3.8476514650e-03 +715 7.1500000000e+00 -8.3206887140e-03 -4.4744244140e-03 +716 7.1600000000e+00 -8.2729093820e-03 -5.0946981770e-03 +717 7.1700000000e+00 -8.2192418120e-03 -5.6718145680e-03 +718 7.1800000000e+00 -8.1603030520e-03 -6.1692539840e-03 +719 7.1900000000e+00 -8.0970780500e-03 -6.5487676050e-03 +720 7.2000000000e+00 -8.0309196620e-03 -6.7272229100e-03 +721 7.2100000000e+00 -7.9634907270e-03 -6.7259642140e-03 +722 7.2200000000e+00 -7.8964744890e-03 -6.6789598430e-03 +723 7.2300000000e+00 -7.8312850050e-03 -6.4221789350e-03 +724 7.2400000000e+00 -7.7690092330e-03 -6.0751032250e-03 +725 7.2500000000e+00 -7.7104070320e-03 -5.6689224870e-03 +726 7.2600000000e+00 -7.6559111550e-03 -5.2359769820e-03 +727 7.2700000000e+00 -7.6056272590e-03 -4.8087903910e-03 +728 7.2800000000e+00 -7.5593338980e-03 -4.4198555860e-03 +729 7.2900000000e+00 -7.5164825260e-03 -4.1030087070e-03 +730 7.3000000000e+00 -7.4761974950e-03 -3.8973776310e-03 +731 7.3100000000e+00 -7.4373205220e-03 -3.8759720650e-03 +732 7.3200000000e+00 -7.3986330090e-03 -3.8773675230e-03 +733 7.3300000000e+00 -7.3590783700e-03 -4.0015934670e-03 +734 7.3400000000e+00 -7.3178064890e-03 -4.2169764230e-03 +735 7.3500000000e+00 -7.2741737280e-03 -4.4858423140e-03 +736 7.3600000000e+00 -7.2277429200e-03 -4.7879201620e-03 +737 7.3700000000e+00 -7.1782833720e-03 -5.1026918510e-03 +738 7.3800000000e+00 -7.1257708670e-03 -5.4095927810e-03 +739 7.3900000000e+00 -7.0703876590e-03 -5.6872718710e-03 +740 7.4000000000e+00 -7.0125224790e-03 -5.9122800580e-03 +741 7.4100000000e+00 -6.9527445490e-03 -6.0705847630e-03 +742 7.4200000000e+00 -6.8916736910e-03 -6.1675051450e-03 +743 7.4300000000e+00 -6.8298504240e-03 -6.2135136040e-03 +744 7.4400000000e+00 -6.7677099870e-03 -6.2133123600e-03 +745 7.4500000000e+00 -6.7055823390e-03 -6.2119432270e-03 +746 7.4600000000e+00 -6.6436921590e-03 -6.1750902160e-03 +747 7.4700000000e+00 -6.5821588440e-03 -6.1325376130e-03 +748 7.4800000000e+00 -6.5209965140e-03 -6.0933858940e-03 +749 7.4900000000e+00 -6.4601140040e-03 -6.0833932360e-03 +750 7.5000000000e+00 -6.3993148730e-03 -6.0828678280e-03 +751 7.5100000000e+00 -6.3383152770e-03 -6.1110319720e-03 +752 7.5200000000e+00 -6.2768333710e-03 -6.1744378110e-03 +753 7.5300000000e+00 -6.2146787090e-03 -6.2517322550e-03 +754 7.5400000000e+00 -6.1517701230e-03 -6.3316236530e-03 +755 7.5500000000e+00 -6.0881357210e-03 -6.4034456450e-03 +756 7.5600000000e+00 -6.0239128920e-03 -6.4556549940e-03 +757 7.5700000000e+00 -5.9593483000e-03 -6.4558690390e-03 +758 7.5800000000e+00 -5.8947978880e-03 -6.4544047390e-03 +759 7.5900000000e+00 -5.8307268780e-03 -6.3840366970e-03 +760 7.6000000000e+00 -5.7677097690e-03 -6.2482392170e-03 +761 7.6100000000e+00 -5.7064038390e-03 -6.0415350870e-03 +762 7.6200000000e+00 -5.6474166590e-03 -5.7781975640e-03 +763 7.6300000000e+00 -5.5911735990e-03 -5.4820877910e-03 +764 7.6400000000e+00 -5.5378913320e-03 -5.1747939830e-03 +765 7.6500000000e+00 -5.4875778360e-03 -4.8770962220e-03 +766 7.6600000000e+00 -5.4400323880e-03 -4.6097357670e-03 +767 7.6700000000e+00 -5.3948455730e-03 -4.3932287400e-03 +768 7.6800000000e+00 -5.3513992750e-03 -4.2592350550e-03 +769 7.6900000000e+00 -5.3088666840e-03 -4.2582276760e-03 +770 7.7000000000e+00 -5.2662122910e-03 -4.2715994810e-03 +771 7.7100000000e+00 -5.2222317010e-03 -4.4675543320e-03 +772 7.7200000000e+00 -5.1757506940e-03 -4.7782011870e-03 +773 7.7300000000e+00 -5.1258242750e-03 -5.1707250140e-03 +774 7.7400000000e+00 -5.0717764940e-03 -5.6171552670e-03 +775 7.7500000000e+00 -5.0132004380e-03 -6.0907404020e-03 +776 7.7600000000e+00 -4.9499582360e-03 -6.5646596010e-03 +777 7.7700000000e+00 -4.8821810580e-03 -7.0120917520e-03 +778 7.7800000000e+00 -4.8102691140e-03 -7.4062816260e-03 +779 7.7900000000e+00 -4.7348916560e-03 -7.7192866600e-03 +780 7.8000000000e+00 -4.6569869740e-03 -7.9185010720e-03 +781 7.8100000000e+00 -4.5777234760e-03 -7.9357116620e-03 +782 7.8200000000e+00 -4.4983050530e-03 -7.9345538390e-03 +783 7.8300000000e+00 -4.4197764540e-03 -7.8056778610e-03 +784 7.8400000000e+00 -4.3429843580e-03 -7.5886231250e-03 +785 7.8500000000e+00 -4.2685773750e-03 -7.3171269070e-03 +786 7.8600000000e+00 -4.1970060460e-03 -7.0106527050e-03 +787 7.8700000000e+00 -4.1285228410e-03 -6.6888898820e-03 +788 7.8800000000e+00 -4.0631821630e-03 -6.3715753420e-03 +789 7.8900000000e+00 -4.0008403430e-03 -6.0790957490e-03 +790 7.9000000000e+00 -3.9411556450e-03 -5.8334960980e-03 +791 7.9100000000e+00 -3.8836100890e-03 -5.6490249270e-03 +792 7.9200000000e+00 -3.8276185730e-03 -5.5238274960e-03 +793 7.9300000000e+00 -3.7726380060e-03 -5.4503718460e-03 +794 7.9400000000e+00 -3.7181891260e-03 -5.4368290110e-03 +795 7.9500000000e+00 -3.6638565070e-03 -5.4375412710e-03 +796 7.9600000000e+00 -3.6092885500e-03 -5.4693271350e-03 +797 7.9700000000e+00 -3.5541974930e-03 -5.5364281040e-03 +798 7.9800000000e+00 -3.4983594020e-03 -5.6225227740e-03 +799 7.9900000000e+00 -3.4416141800e-03 -5.7213422600e-03 +800 8.0000000000e+00 -3.3838655570e-03 -5.8264552150e-03 +801 8.0100000000e+00 -3.3250799920e-03 -5.9317600090e-03 +802 8.0200000000e+00 -3.2652811390e-03 -6.0319529100e-03 +803 8.0300000000e+00 -3.2045443190e-03 -6.1220872130e-03 +804 8.0400000000e+00 -3.1429954090e-03 -6.1971772310e-03 +805 8.0500000000e+00 -3.0808108470e-03 -6.2523344830e-03 +806 8.0600000000e+00 -3.0182176310e-03 -6.2681669500e-03 +807 8.0700000000e+00 -2.9554933170e-03 -6.2687770620e-03 +808 8.0800000000e+00 -2.8929660200e-03 -6.2432932110e-03 +809 8.0900000000e+00 -2.8310144160e-03 -6.1668903030e-03 +810 8.1000000000e+00 -2.7700677390e-03 -6.0438459020e-03 +811 8.1100000000e+00 -2.7105918050e-03 -5.8720071740e-03 +812 8.1200000000e+00 -2.6530191240e-03 -5.6595409670e-03 +813 8.1300000000e+00 -2.5976790150e-03 -5.4196416380e-03 +814 8.1400000000e+00 -2.5447836260e-03 -5.1644165190e-03 +815 8.1500000000e+00 -2.4944279380e-03 -4.9055584030e-03 +816 8.1600000000e+00 -2.4465897580e-03 -4.6547632950e-03 +817 8.1700000000e+00 -2.4011297280e-03 -4.4237188540e-03 +818 8.1800000000e+00 -2.3577913170e-03 -4.2240813640e-03 +819 8.1900000000e+00 -2.3162008250e-03 -4.0681406080e-03 +820 8.2000000000e+00 -2.2758673830e-03 -3.9706319740e-03 +821 8.2100000000e+00 -2.2362029790e-03 -3.9611717460e-03 +822 8.2200000000e+00 -2.1966225940e-03 -3.9620151530e-03 +823 8.2300000000e+00 -2.1566443350e-03 -4.0194821090e-03 +824 8.2400000000e+00 -2.1159094640e-03 -4.1138208480e-03 +825 8.2500000000e+00 -2.0741823980e-03 -4.2252451690e-03 +826 8.2600000000e+00 -2.0313507070e-03 -4.3416947870e-03 +827 8.2700000000e+00 -1.9874251180e-03 -4.4510024540e-03 +828 8.2800000000e+00 -1.9425395100e-03 -4.5411700940e-03 +829 8.2900000000e+00 -1.8969509160e-03 -4.5850896530e-03 +830 8.3000000000e+00 -1.8510395260e-03 -4.5858122980e-03 +831 8.3100000000e+00 -1.8052902620e-03 -4.5663005390e-03 +832 8.3200000000e+00 -1.7602006790e-03 -4.4744051230e-03 +833 8.3300000000e+00 -1.7161888630e-03 -4.3453380180e-03 +834 8.3400000000e+00 -1.6735750130e-03 -4.1893095180e-03 +835 8.3500000000e+00 -1.6325814350e-03 -4.0160059210e-03 +836 8.3600000000e+00 -1.5933325480e-03 -3.8351750510e-03 +837 8.3700000000e+00 -1.5558548830e-03 -3.6565797610e-03 +838 8.3800000000e+00 -1.5200770810e-03 -3.4899795860e-03 +839 8.3900000000e+00 -1.4858298910e-03 -3.3455567640e-03 +840 8.4000000000e+00 -1.4528461780e-03 -3.2346895450e-03 +841 8.4100000000e+00 -1.4207748020e-03 -3.1637014420e-03 +842 8.4200000000e+00 -1.3892500700e-03 -3.1291533650e-03 +843 8.4300000000e+00 -1.3579611770e-03 -3.1292408310e-03 +844 8.4400000000e+00 -1.3266660940e-03 -3.1298911790e-03 +845 8.4500000000e+00 -1.2951915690e-03 -3.1576610340e-03 +846 8.4600000000e+00 -1.2634331300e-03 -3.1917512150e-03 +847 8.4700000000e+00 -1.2313550790e-03 -3.2259651180e-03 +848 8.4800000000e+00 -1.1989904980e-03 -3.2540630400e-03 +849 8.4900000000e+00 -1.1664412430e-03 -3.2555693480e-03 +850 8.5000000000e+00 -1.1338779510e-03 -3.2557025210e-03 +851 8.5100000000e+00 -1.1015326060e-03 -3.2234865450e-03 +852 8.5200000000e+00 -1.0696614040e-03 -3.1630718910e-03 +853 8.5300000000e+00 -1.0385076140e-03 -3.0791159010e-03 +854 8.5400000000e+00 -1.0082941500e-03 -2.9739076870e-03 +855 8.5500000000e+00 -9.7922357050e-04 -2.8494714080e-03 +856 8.5600000000e+00 -9.5147808060e-04 -2.7078379130e-03 +857 8.5700000000e+00 -9.2521952960e-04 -2.5510405740e-03 +858 8.5800000000e+00 -9.0058941240e-04 -2.3811136250e-03 +859 8.5900000000e+00 -8.7770886890e-04 -2.2000297810e-03 +860 8.6000000000e+00 -8.5667868430e-04 -2.0096305180e-03 +861 8.6100000000e+00 -8.3757669380e-04 -1.8125777800e-03 +862 8.6200000000e+00 -8.2044480670e-04 -1.6133743580e-03 +863 8.6300000000e+00 -8.0527603090e-04 -1.4173768830e-03 +864 8.6400000000e+00 -7.9201187730e-04 -1.2297980360e-03 +865 8.6500000000e+00 -7.8054236030e-04 -1.0557824940e-03 +866 8.6600000000e+00 -7.7070599730e-04 -9.0047077190e-04 +867 8.6700000000e+00 -7.6228980900e-04 -7.6899201130e-04 +868 8.6800000000e+00 -7.5502931930e-04 -6.6643613270e-04 +869 8.6900000000e+00 -7.4860855550e-04 -5.9822957020e-04 +870 8.7000000000e+00 -7.4266004790e-04 -5.9102166820e-04 +871 8.7100000000e+00 -7.3677624910e-04 -5.9136220610e-04 +872 8.7200000000e+00 -7.3056662870e-04 -6.3841529490e-04 +873 8.7300000000e+00 -7.2371476810e-04 -7.1895190120e-04 +874 8.7400000000e+00 -7.1598977950e-04 -8.1806870680e-04 +875 8.7500000000e+00 -7.0724630570e-04 -9.2737467390e-04 +876 8.7600000000e+00 -6.9742452050e-04 -1.0383773450e-03 +877 8.7700000000e+00 -6.8655012820e-04 -1.1425742970e-03 +878 8.7800000000e+00 -6.7473436410e-04 -1.2315130470e-03 +879 8.7900000000e+00 -6.6217399400e-04 -1.2963584120e-03 +880 8.8000000000e+00 -6.4915131470e-04 -1.3094343440e-03 +881 8.8100000000e+00 -6.3601950570e-04 -1.3089678270e-03 +882 8.8200000000e+00 -6.2312938900e-04 -1.2757712740e-03 +883 8.8300000000e+00 -6.1075618940e-04 -1.2096983960e-03 +884 8.8400000000e+00 -5.9908488620e-04 -1.1299283140e-03 +885 8.8500000000e+00 -5.8821021300e-04 -1.0452584110e-03 +886 8.8600000000e+00 -5.7813665840e-04 -9.6460283190e-04 +887 8.8700000000e+00 -5.6877846530e-04 -8.9678568750e-04 +888 8.8800000000e+00 -5.5995963120e-04 -8.5822913660e-04 +889 8.8900000000e+00 -5.5141390820e-04 -8.5747478260e-04 +890 8.9000000000e+00 -5.4278480290e-04 -8.6716956740e-04 +891 8.9100000000e+00 -5.3364421720e-04 -9.4133837340e-04 +892 8.9200000000e+00 -5.2358565110e-04 -1.0544350220e-03 +893 8.9300000000e+00 -5.1231740570e-04 -1.1904098590e-03 +894 8.9400000000e+00 -4.9968122430e-04 -1.3354564220e-03 +895 8.9500000000e+00 -4.8565229150e-04 -1.4763473930e-03 +896 8.9600000000e+00 -4.7033923410e-04 -1.5999042110e-03 +897 8.9700000000e+00 -4.5398412050e-04 -1.6934097630e-03 +898 8.9800000000e+00 -4.3696246120e-04 -1.7112894550e-03 +899 8.9900000000e+00 -4.1978320830e-04 -1.7124335300e-03 +900 9.0000000000e+00 -4.0308875560e-04 -1.6449196520e-03 +901 9.0100000000e+00 -3.8762791010e-04 -1.4817040520e-03 +902 9.0200000000e+00 -3.7412074740e-04 -1.2491702780e-03 +903 9.0300000000e+00 -3.6312346700e-04 -9.6992461550e-04 +904 9.0400000000e+00 -3.5500136390e-04 -6.6380635360e-04 +905 9.0500000000e+00 -3.4992882860e-04 -3.4982061670e-04 +906 9.0600000000e+00 -3.4788934670e-04 -4.6993457500e-05 +907 9.0700000000e+00 -3.4867549920e-04 2.2568020250e-04 +908 9.0800000000e+00 -3.5188896250e-04 4.4935964540e-04 +909 9.0900000000e+00 -3.5694050820e-04 6.0452910960e-04 +910 9.1000000000e+00 -3.6305000340e-04 6.1763862860e-04 +911 9.1100000000e+00 -3.6927825380e-04 6.1715722710e-04 +912 9.1200000000e+00 -3.7468622130e-04 4.9717594620e-04 +913 9.1300000000e+00 -3.7849424120e-04 2.9714995560e-04 +914 9.1400000000e+00 -3.8011386570e-04 4.8341320950e-05 +915 9.1500000000e+00 -3.7914786360e-04 -2.3046620100e-04 +916 9.1600000000e+00 -3.7539022070e-04 -5.2026924870e-04 +917 9.1700000000e+00 -3.6882613980e-04 -8.0202351890e-04 +918 9.1800000000e+00 -3.5963204020e-04 -1.0567133440e-03 +919 9.1900000000e+00 -3.4817555830e-04 -1.2645602590e-03 +920 9.2000000000e+00 -3.3501554730e-04 -1.4029450680e-03 +921 9.2100000000e+00 -3.2087683960e-04 -1.4283913870e-03 +922 9.2200000000e+00 -3.0652406010e-04 -1.4272958700e-03 +923 9.2300000000e+00 -2.9263543830e-04 -1.3643256150e-03 +924 9.2400000000e+00 -2.7977757160e-04 -1.2322371450e-03 +925 9.2500000000e+00 -2.6840542450e-04 -1.0605904210e-03 +926 9.2600000000e+00 -2.5886232930e-04 -8.6031093940e-04 +927 9.2700000000e+00 -2.5137998560e-04 -6.4249036470e-04 +928 9.2800000000e+00 -2.4607846060e-04 -4.1825876870e-04 +929 9.2900000000e+00 -2.4296618900e-04 -1.9902305240e-04 +930 9.3000000000e+00 -2.4193997290e-04 3.1845693800e-06 +931 9.3100000000e+00 -2.4279467890e-04 1.7966093380e-04 +932 9.3200000000e+00 -2.4527172140e-04 3.2868016980e-04 +933 9.3300000000e+00 -2.4910754640e-04 4.5137591900e-04 +934 9.3400000000e+00 -2.5404332870e-04 5.4842279990e-04 +935 9.3500000000e+00 -2.5982497130e-04 6.2029030100e-04 +936 9.3600000000e+00 -2.6620310570e-04 6.6743896290e-04 +937 9.3700000000e+00 -2.7293309200e-04 6.8128886900e-04 +938 9.3800000000e+00 -2.7977501880e-04 6.8122989380e-04 +939 9.3900000000e+00 -2.8649370290e-04 6.6561682560e-04 +940 9.4000000000e+00 -2.9285868980e-04 6.1822347770e-04 +941 9.4100000000e+00 -2.9864964660e-04 5.4912675690e-04 +942 9.4200000000e+00 -3.0368332670e-04 4.6394228000e-04 +943 9.4300000000e+00 -3.0784053560e-04 3.7019047190e-04 +944 9.4400000000e+00 -3.1107152360e-04 2.7494326710e-04 +945 9.4500000000e+00 -3.1339598590e-04 1.8510907390e-04 +946 9.4600000000e+00 -3.1490306250e-04 1.0756448490e-04 +947 9.4700000000e+00 -3.1575133810e-04 4.8999593660e-05 +948 9.4800000000e+00 -3.1616884250e-04 3.3107920740e-05 +949 9.4900000000e+00 -3.1645305020e-04 3.2380561200e-05 +950 9.5000000000e+00 -3.1697088070e-04 6.3754272530e-05 +951 9.5100000000e+00 -3.1814184860e-04 1.5167878300e-04 +952 9.5200000000e+00 -3.2035381530e-04 2.7601805580e-04 +953 9.5300000000e+00 -3.2387874080e-04 4.2128484640e-04 +954 9.5400000000e+00 -3.2885583420e-04 5.7377933880e-04 +955 9.5500000000e+00 -3.3529155330e-04 7.2032706750e-04 +956 9.5600000000e+00 -3.4305960490e-04 8.4781313400e-04 +957 9.5700000000e+00 -3.5190094460e-04 9.4358916640e-04 +958 9.5800000000e+00 -3.6142377720e-04 9.6133332950e-04 +959 9.5900000000e+00 -3.7110355600e-04 9.6244725480e-04 +960 9.6000000000e+00 -3.8028298350e-04 8.9260370630e-04 +961 9.6100000000e+00 -3.8819947730e-04 7.2570100330e-04 +962 9.6200000000e+00 -3.9412250090e-04 4.8863488130e-04 +963 9.6300000000e+00 -3.9749089540e-04 2.0465082210e-04 +964 9.6400000000e+00 -3.9794034490e-04 -1.0580965950e-04 +965 9.6500000000e+00 -3.9530337710e-04 -4.2315129320e-04 +966 9.6600000000e+00 -3.8960936300e-04 -7.2775947590e-04 +967 9.6700000000e+00 -3.8108451720e-04 -1.0000584900e-03 +968 9.6800000000e+00 -3.7015189750e-04 -1.2206640990e-03 +969 9.6900000000e+00 -3.5743140510e-04 -1.3686784530e-03 +970 9.7000000000e+00 -3.4373978450e-04 -1.3687177910e-03 +971 9.7100000000e+00 -3.3005711180e-04 -1.3677771240e-03 +972 9.7200000000e+00 -3.1735923270e-04 -1.2175506400e-03 +973 9.7300000000e+00 -3.0645020200e-04 -9.9744243200e-04 +974 9.7400000000e+00 -2.9792877150e-04 -7.2818771020e-04 +975 9.7500000000e+00 -2.9218838950e-04 -4.3000627220e-04 +976 9.7600000000e+00 -2.8941720110e-04 -1.2331077010e-04 +977 9.7700000000e+00 -2.8959804820e-04 1.7145429420e-04 +978 9.7800000000e+00 -2.9250846960e-04 4.3389135570e-04 +979 9.7900000000e+00 -2.9772070050e-04 6.4262374950e-04 +980 9.8000000000e+00 -3.0460167320e-04 7.7223408700e-04 +981 9.8100000000e+00 -3.1234484370e-04 7.7669650150e-04 +982 9.8200000000e+00 -3.2012932700e-04 7.7621752470e-04 +983 9.8300000000e+00 -3.2727903260e-04 6.8055189370e-04 +984 9.8400000000e+00 -3.3329449150e-04 5.4117460460e-04 +985 9.8500000000e+00 -3.3785285590e-04 3.7873497620e-04 +986 9.8600000000e+00 -3.4080789960e-04 2.1056974260e-04 +987 9.8700000000e+00 -3.4219001780e-04 5.4129325750e-05 +988 9.8800000000e+00 -3.4220622720e-04 -7.3421138480e-05 +989 9.8900000000e+00 -3.4124016580e-04 -1.2932529480e-04 +990 9.9000000000e+00 -3.3985209320e-04 -1.3027960630e-04 +991 9.9100000000e+00 -3.3874868130e-04 -9.4889177100e-05 +992 9.9200000000e+00 -3.3863196930e-04 4.0847818400e-05 +993 9.9300000000e+00 -3.4004831890e-04 2.2224472680e-04 +994 9.9400000000e+00 -3.4335820470e-04 4.3012047260e-04 +995 9.9500000000e+00 -3.4873621490e-04 6.4610107190e-04 +996 9.9600000000e+00 -3.5617105070e-04 8.5173520200e-04 +997 9.9700000000e+00 -3.6546552680e-04 1.0286755720e-03 +998 9.9800000000e+00 -3.7623657080e-04 1.1593557180e-03 +999 9.9900000000e+00 -3.8791522390e-04 1.1761944840e-03 +1000 1.0000000000e+01 -3.9974664040e-04 1.1767838920e-03 +1001 1.0010000000e+01 -4.1082104180e-04 1.0677225170e-03 +1002 1.0020000000e+01 -4.2022926040e-04 8.5414149960e-04 +1003 1.0030000000e+01 -4.2721876140e-04 5.7407440180e-04 +1004 1.0040000000e+01 -4.3122515020e-04 2.4718443700e-04 +1005 1.0050000000e+01 -4.3187226610e-04 -1.0782601200e-04 +1006 1.0060000000e+01 -4.2897216000e-04 -4.7219506290e-04 +1007 1.0070000000e+01 -4.2252495590e-04 -8.2716579100e-04 +1008 1.0080000000e+01 -4.1271859740e-04 -1.1540259710e-03 +1009 1.0090000000e+01 -3.9992847830e-04 -1.4333717600e-03 +1010 1.0100000000e+01 -3.8471695790e-04 -1.6437078990e-03 +1011 1.0110000000e+01 -3.6780865340e-04 -1.7721885790e-03 +1012 1.0120000000e+01 -3.4996932360e-04 -1.8019117800e-03 +1013 1.0130000000e+01 -3.3188505560e-04 -1.8006379560e-03 +1014 1.0140000000e+01 -3.1413816540e-04 -1.7566778600e-03 +1015 1.0150000000e+01 -2.9720729950e-04 -1.6504364580e-03 +1016 1.0160000000e+01 -2.8146759970e-04 -1.5122390050e-03 +1017 1.0170000000e+01 -2.6719093180e-04 -1.3521402890e-03 +1018 1.0180000000e+01 -2.5454617650e-04 -1.1803480910e-03 +1019 1.0190000000e+01 -2.4359958460e-04 -1.0073204990e-03 +1020 1.0200000000e+01 -2.3431519470e-04 -8.4406428450e-04 +1021 1.0210000000e+01 -2.2656453160e-04 -6.9838951460e-04 +1022 1.0220000000e+01 -2.2017314520e-04 -5.7144880500e-04 +1023 1.0230000000e+01 -2.1496692380e-04 -4.6164139160e-04 +1024 1.0240000000e+01 -2.1078135050e-04 -3.6780651980e-04 +1025 1.0250000000e+01 -2.0746151260e-04 -2.8898365970e-04 +1026 1.0260000000e+01 -2.0486210460e-04 -2.2421250740e-04 +1027 1.0270000000e+01 -2.0284742580e-04 -1.7253368530e-04 +1028 1.0280000000e+01 -2.0129137260e-04 -1.3299015590e-04 +1029 1.0290000000e+01 -2.0007742360e-04 -1.0462481120e-04 +1030 1.0300000000e+01 -1.9909862130e-04 -8.6482093950e-05 +1031 1.0310000000e+01 -1.9825740620e-04 -8.0176145770e-05 +1032 1.0320000000e+01 -1.9746489060e-04 -8.0270475810e-05 +1033 1.0330000000e+01 -1.9664013180e-04 -8.4149519230e-05 +1034 1.0340000000e+01 -1.9570996480e-04 -9.8408753000e-05 +1035 1.0350000000e+01 -1.9460896870e-04 -1.1878674230e-04 +1036 1.0360000000e+01 -1.9327943030e-04 -1.4453939260e-04 +1037 1.0370000000e+01 -1.9167130140e-04 -1.7490855840e-04 +1038 1.0380000000e+01 -1.8974215350e-04 -2.0913698290e-04 +1039 1.0390000000e+01 -1.8745712570e-04 -2.4647791360e-04 +1040 1.0400000000e+01 -1.8478887050e-04 -2.8620364200e-04 +1041 1.0410000000e+01 -1.8171776410e-04 -3.2750670860e-04 +1042 1.0420000000e+01 -1.7823319480e-04 -3.6939422980e-04 +1043 1.0430000000e+01 -1.7433482900e-04 -4.1079442840e-04 +1044 1.0440000000e+01 -1.7003277440e-04 -4.5066219870e-04 +1045 1.0450000000e+01 -1.6534746400e-04 -4.8797153340e-04 +1046 1.0460000000e+01 -1.6030953380e-04 -5.2170945500e-04 +1047 1.0470000000e+01 -1.5495969400e-04 -5.5087748210e-04 +1048 1.0480000000e+01 -1.4934859350e-04 -5.7449468730e-04 +1049 1.0490000000e+01 -1.4353667910e-04 -5.9151095890e-04 +1050 1.0500000000e+01 -1.3759404780e-04 -5.9895751610e-04 +1051 1.0510000000e+01 -1.3159786030e-04 -5.9884024670e-04 +1052 1.0520000000e+01 -1.2562008510e-04 -5.9671537190e-04 +1053 1.0530000000e+01 -1.1971541890e-04 -5.8645497820e-04 +1054 1.0540000000e+01 -1.1391907460e-04 -5.7377073050e-04 +1055 1.0550000000e+01 -1.0824702940e-04 -5.6047034270e-04 +1056 1.0560000000e+01 -1.0269628380e-04 -5.4839149330e-04 +1057 1.0570000000e+01 -9.7245133280e-05 -5.3923980200e-04 +1058 1.0580000000e+01 -9.1853451120e-05 -5.3911449470e-04 +1059 1.0590000000e+01 -8.6462982460e-05 -5.3910199430e-04 +1060 1.0600000000e+01 -8.0997650220e-05 -5.5041729600e-04 +1061 1.0610000000e+01 -7.5368739520e-05 -5.7173059930e-04 +1062 1.0620000000e+01 -6.9499402950e-05 -5.9987988550e-04 +1063 1.0630000000e+01 -6.3348728690e-05 -6.3019444120e-04 +1064 1.0640000000e+01 -5.6916004900e-05 -6.5859860260e-04 +1065 1.0650000000e+01 -5.0240052900e-05 -6.8133908400e-04 +1066 1.0660000000e+01 -4.3398535910e-05 -6.8721567780e-04 +1067 1.0670000000e+01 -3.6507243520e-05 -6.8762860290e-04 +1068 1.0680000000e+01 -2.9719352220e-05 -6.7391683480e-04 +1069 1.0690000000e+01 -2.3224662110e-05 -6.3517303510e-04 +1070 1.0700000000e+01 -1.7248809950e-05 -5.7135297940e-04 +1071 1.0710000000e+01 -1.2043859570e-05 -4.8077252260e-04 +1072 1.0720000000e+01 -7.8448100750e-06 -3.6813962720e-04 +1073 1.0730000000e+01 -4.8270281820e-06 -2.4116727060e-04 +1074 1.0740000000e+01 -3.0987780870e-06 -1.0674709090e-04 +1075 1.0750000000e+01 -2.7024744570e-06 2.8614036460e-05 +1076 1.0760000000e+01 -3.6159753210e-06 1.5853729430e-04 +1077 1.0770000000e+01 -5.7539145360e-06 2.7678298170e-04 +1078 1.0780000000e+01 -8.9690733710e-06 3.7726806870e-04 +1079 1.0790000000e+01 -1.3053790830e-05 4.5374751230e-04 +1080 1.0800000000e+01 -1.7741412250e-05 4.9645783070e-04 +1081 1.0810000000e+01 -2.2717402080e-05 4.9635768930e-04 +1082 1.0820000000e+01 -2.7668550310e-05 4.9373434340e-04 +1083 1.0830000000e+01 -3.2330964780e-05 4.5092721080e-04 +1084 1.0840000000e+01 -3.6498647170e-05 3.9091840760e-04 +1085 1.0850000000e+01 -4.0022298200e-05 3.1893553480e-04 +1086 1.0860000000e+01 -4.2808089230e-05 2.4038641930e-04 +1087 1.0870000000e+01 -4.4816400650e-05 1.6059919060e-04 +1088 1.0880000000e+01 -4.6060527570e-05 8.4780110980e-05 +1089 1.0890000000e+01 -4.6605352970e-05 1.8223653080e-05 +1090 1.0900000000e+01 -4.6565988960e-05 -3.3314987920e-05 +1091 1.0910000000e+01 -4.6099238430e-05 -6.6873796480e-05 +1092 1.0920000000e+01 -4.5366824730e-05 -8.4916136160e-05 +1093 1.0930000000e+01 -4.4499679130e-05 -9.0355700370e-05 +1094 1.0940000000e+01 -4.3591609800e-05 -8.9952927120e-05 +1095 1.0950000000e+01 -4.2700237280e-05 -8.7651375340e-05 +1096 1.0960000000e+01 -4.1847951690e-05 -8.3360830850e-05 +1097 1.0970000000e+01 -4.1022891310e-05 -8.2903739490e-05 +1098 1.0980000000e+01 -4.0179942230e-05 -8.5063482370e-05 +1099 1.0990000000e+01 -3.9241758770e-05 -9.8313192120e-05 +1100 1.1000000000e+01 -3.8099804360e-05 -1.2447822810e-04 +1101 1.1010000000e+01 -3.6621345410e-05 -1.6534170470e-04 +1102 1.1020000000e+01 -3.4679816320e-05 -2.1818064580e-04 +1103 1.1030000000e+01 -3.2184148770e-05 -2.7819907000e-04 +1104 1.1040000000e+01 -2.9083598200e-05 -3.4125702240e-04 +1105 1.1050000000e+01 -2.5366519500e-05 -4.0351991940e-04 +1106 1.1060000000e+01 -2.1059118990e-05 -4.6127744400e-04 +1107 1.1070000000e+01 -1.6224183250e-05 -5.1095646380e-04 +1108 1.1080000000e+01 -1.0959784980e-05 -5.4915926570e-04 +1109 1.1090000000e+01 -5.3979664600e-06 -5.6732102600e-04 +1110 1.1100000000e+01 2.9659907510e-07 -5.6742631160e-04 +1111 1.1110000000e+01 5.9341452010e-06 -5.6066382740e-04 +1112 1.1120000000e+01 1.1331617930e-05 -5.2705013840e-04 +1113 1.1130000000e+01 1.6343217970e-05 -4.8102892890e-04 +1114 1.1140000000e+01 2.0865295550e-05 -4.2682936100e-04 +1115 1.1150000000e+01 2.4834928580e-05 -3.6840379250e-04 +1116 1.1160000000e+01 2.8228476910e-05 -3.0958860270e-04 +1117 1.1170000000e+01 3.1060112970e-05 -2.5407827860e-04 +1118 1.1180000000e+01 3.3380329340e-05 -2.0541192570e-04 +1119 1.1190000000e+01 3.5274423720e-05 -1.6718237570e-04 +1120 1.1200000000e+01 3.6860961690e-05 -1.4358272690e-04 +1121 1.1210000000e+01 3.8283995600e-05 -1.4050599770e-04 +1122 1.1220000000e+01 3.9680922010e-05 -1.4091331570e-04 +1123 1.1230000000e+01 4.1151837300e-05 -1.5145488130e-04 +1124 1.1240000000e+01 4.2754890750e-05 -1.6788298170e-04 +1125 1.1250000000e+01 4.4508020530e-05 -1.8405361040e-04 +1126 1.1260000000e+01 4.6390713930e-05 -1.9455426310e-04 +1127 1.1270000000e+01 4.8345791250e-05 -1.9485241340e-04 +1128 1.1280000000e+01 5.0281212820e-05 -1.9265493800e-04 +1129 1.1290000000e+01 5.2071908600e-05 -1.7208895670e-04 +1130 1.1300000000e+01 5.3561629730e-05 -1.3367792980e-04 +1131 1.1310000000e+01 5.4572080700e-05 -7.6096086180e-05 +1132 1.1320000000e+01 5.4940349260e-05 -3.4911970810e-06 +1133 1.1330000000e+01 5.4554256440e-05 7.7596661070e-05 +1134 1.1340000000e+01 5.3357134590e-05 1.6154909480e-04 +1135 1.1350000000e+01 5.1345125320e-05 2.4323900560e-04 +1136 1.1360000000e+01 4.8564445820e-05 3.1781175050e-04 +1137 1.1370000000e+01 4.5108624410e-05 3.8070237770e-04 +1138 1.1380000000e+01 4.1115706090e-05 4.2768998170e-04 +1139 1.1390000000e+01 3.6765429140e-05 4.4569996240e-04 +1140 1.1400000000e+01 3.2276373320e-05 4.4577483730e-04 +1141 1.1410000000e+01 2.7894657000e-05 4.3230431740e-04 +1142 1.1420000000e+01 2.3849973670e-05 3.8651116970e-04 +1143 1.1430000000e+01 2.0314535340e-05 3.2680232760e-04 +1144 1.1440000000e+01 1.7397851760e-05 2.5938783110e-04 +1145 1.1450000000e+01 1.5150232920e-05 1.8994220910e-04 +1146 1.1460000000e+01 1.3566325960e-05 1.2382271180e-04 +1147 1.1470000000e+01 1.2588685570e-05 6.6028107650e-05 +1148 1.1480000000e+01 1.2111376660e-05 2.1147970850e-05 +1149 1.1490000000e+01 1.1983608170e-05 -5.5445510610e-07 +1150 1.1500000000e+01 1.2013397080e-05 -6.3433927090e-07 +1151 1.1510000000e+01 1.1979618440e-05 6.9224805850e-06 +1152 1.1520000000e+01 1.1676213710e-05 4.4864949350e-05 +1153 1.1530000000e+01 1.0952841300e-05 9.4560562700e-05 +1154 1.1540000000e+01 9.7194851630e-06 1.5011734680e-04 +1155 1.1550000000e+01 7.9423493170e-06 2.0620127250e-04 +1156 1.1560000000e+01 5.6397197640e-06 2.5785045690e-04 +1157 1.1570000000e+01 2.8777951330e-06 3.0053260610e-04 +1158 1.1580000000e+01 -2.3351266940e-07 3.3028724980e-04 +1159 1.1590000000e+01 -3.5448065280e-06 3.3191037270e-04 +1160 1.1600000000e+01 -6.8714595930e-06 3.3193028550e-04 +1161 1.1610000000e+01 -1.0004797940e-05 3.0304498820e-04 +1162 1.1620000000e+01 -1.2749539600e-05 2.5408763700e-04 +1163 1.1630000000e+01 -1.4957470800e-05 1.9293355440e-04 +1164 1.1640000000e+01 -1.6530760420e-05 1.2458386860e-04 +1165 1.1650000000e+01 -1.7418004970e-05 5.3446519620e-05 +1166 1.1660000000e+01 -1.7610248450e-05 -1.6448088780e-05 +1167 1.1670000000e+01 -1.7136978150e-05 -8.1464308840e-05 +1168 1.1680000000e+01 -1.6062097780e-05 -1.3836894190e-04 +1169 1.1690000000e+01 -1.4479879090e-05 -1.8421787100e-04 +1170 1.1700000000e+01 -1.2510893210e-05 -2.1616290120e-04 +1171 1.1710000000e+01 -1.0294430290e-05 -2.3233687030e-04 +1172 1.1720000000e+01 -7.9678780230e-06 -2.3227402260e-04 +1173 1.1730000000e+01 -5.6486954130e-06 -2.3150892740e-04 +1174 1.1740000000e+01 -3.4322545090e-06 -2.1621802220e-04 +1175 1.1750000000e+01 -1.3934204810e-06 -1.9466108350e-04 +1176 1.1760000000e+01 4.1185956270e-07 -1.6850313820e-04 +1177 1.1770000000e+01 1.9449594820e-06 -1.3936779990e-04 +1178 1.1780000000e+01 3.1829692270e-06 -1.0873702930e-04 +1179 1.1790000000e+01 4.1170826780e-06 -7.7937096740e-05 +1180 1.1800000000e+01 4.7509787070e-06 -4.8134899120e-05 +1181 1.1810000000e+01 5.0991788260e-06 -2.0329557190e-05 +1182 1.1820000000e+01 5.1853377300e-06 4.6534024350e-06 +1183 1.1830000000e+01 5.0405482780e-06 2.6153287390e-05 +1184 1.1840000000e+01 4.7017245850e-06 4.3667703640e-05 +1185 1.1850000000e+01 4.2099998780e-06 5.6852853570e-05 +1186 1.1860000000e+01 3.6091206690e-06 6.5520030940e-05 +1187 1.1870000000e+01 2.9438377600e-06 6.8044387790e-05 +1188 1.1880000000e+01 2.2582945630e-06 6.8005776470e-05 +1189 1.1890000000e+01 1.5944132410e-06 6.5247449720e-05 +1190 1.1900000000e+01 9.9027914890e-07 5.7253374050e-05 +1191 1.1910000000e+01 4.7794482020e-07 4.6374107540e-05 +1192 1.1920000000e+01 7.9430367210e-08 3.3872879470e-05 +1193 1.1930000000e+01 -1.9586145530e-07 2.1091406450e-05 +1194 1.1940000000e+01 -3.5038203430e-07 9.1537875640e-06 +1195 1.1950000000e+01 -3.9696232700e-07 -9.8173844310e-07 +1196 1.1960000000e+01 -3.5733509120e-07 -8.5097413050e-06 +1197 1.1970000000e+01 -2.6065437280e-07 -1.1346751290e-05 +1198 1.1980000000e+01 -1.4201270800e-07 -1.1393547340e-05 +1199 1.1990000000e+01 -4.0956496040e-08 -8.7451546660e-06 +1200 1.2000000000e+01 0.0000000000e+00 -1.0906638080e-06 diff --git a/unittest/force-styles/tests/table_CG_CG_CG.txt b/unittest/force-styles/tests/table_CG_CG_CG.txt new file mode 100644 index 0000000000..d6d1c3e71e --- /dev/null +++ b/unittest/force-styles/tests/table_CG_CG_CG.txt @@ -0,0 +1,1004 @@ +VOTCA +N 1001 + +1 0.00000e+00 -6.5399880e+01 -1.4141539e+00 +2 1.80000e-01 -6.5145332e+01 -1.4141539e+00 +3 3.60000e-01 -6.4890785e+01 -1.4141539e+00 +4 5.40000e-01 -6.4636237e+01 -1.4141539e+00 +5 7.20000e-01 -6.4381689e+01 -1.4141539e+00 +6 9.00000e-01 -6.4127142e+01 -1.4141539e+00 +7 1.08000e+00 -6.3872594e+01 -1.4141539e+00 +8 1.26000e+00 -6.3618046e+01 -1.4141539e+00 +9 1.44000e+00 -6.3363498e+01 -1.4141539e+00 +10 1.62000e+00 -6.3108951e+01 -1.4141539e+00 +11 1.80000e+00 -6.2854403e+01 -1.4141539e+00 +12 1.98000e+00 -6.2599855e+01 -1.4141539e+00 +13 2.16000e+00 -6.2345308e+01 -1.4141539e+00 +14 2.34000e+00 -6.2090760e+01 -1.4141539e+00 +15 2.52000e+00 -6.1836212e+01 -1.4141539e+00 +16 2.70000e+00 -6.1581664e+01 -1.4141539e+00 +17 2.88000e+00 -6.1327117e+01 -1.4141539e+00 +18 3.06000e+00 -6.1072569e+01 -1.4141539e+00 +19 3.24000e+00 -6.0818021e+01 -1.4141539e+00 +20 3.42000e+00 -6.0563474e+01 -1.4141539e+00 +21 3.60000e+00 -6.0308926e+01 -1.4141539e+00 +22 3.78000e+00 -6.0054378e+01 -1.4141539e+00 +23 3.96000e+00 -5.9799831e+01 -1.4141539e+00 +24 4.14000e+00 -5.9545283e+01 -1.4141539e+00 +25 4.32000e+00 -5.9290735e+01 -1.4141539e+00 +26 4.50000e+00 -5.9036187e+01 -1.4141539e+00 +27 4.68000e+00 -5.8781640e+01 -1.4141539e+00 +28 4.86000e+00 -5.8527092e+01 -1.4141539e+00 +29 5.04000e+00 -5.8272544e+01 -1.4141539e+00 +30 5.22000e+00 -5.8017997e+01 -1.4141539e+00 +31 5.40000e+00 -5.7763449e+01 -1.4141539e+00 +32 5.58000e+00 -5.7508901e+01 -1.4141539e+00 +33 5.76000e+00 -5.7254354e+01 -1.4141539e+00 +34 5.94000e+00 -5.6999806e+01 -1.4141539e+00 +35 6.12000e+00 -5.6745258e+01 -1.4141539e+00 +36 6.30000e+00 -5.6490710e+01 -1.4141539e+00 +37 6.48000e+00 -5.6236163e+01 -1.4141539e+00 +38 6.66000e+00 -5.5981615e+01 -1.4141539e+00 +39 6.84000e+00 -5.5727067e+01 -1.4141539e+00 +40 7.02000e+00 -5.5472520e+01 -1.4141539e+00 +41 7.20000e+00 -5.5217972e+01 -1.4141539e+00 +42 7.38000e+00 -5.4963424e+01 -1.4141539e+00 +43 7.56000e+00 -5.4708876e+01 -1.4141539e+00 +44 7.74000e+00 -5.4454329e+01 -1.4141539e+00 +45 7.92000e+00 -5.4199781e+01 -1.4141539e+00 +46 8.10000e+00 -5.3945233e+01 -1.4141539e+00 +47 8.28000e+00 -5.3690686e+01 -1.4141539e+00 +48 8.46000e+00 -5.3436138e+01 -1.4141539e+00 +49 8.64000e+00 -5.3181590e+01 -1.4141539e+00 +50 8.82000e+00 -5.2927043e+01 -1.4141539e+00 +51 9.00000e+00 -5.2672495e+01 -1.4141539e+00 +52 9.18000e+00 -5.2417947e+01 -1.4141539e+00 +53 9.36000e+00 -5.2163399e+01 -1.4141539e+00 +54 9.54000e+00 -5.1908852e+01 -1.4141539e+00 +55 9.72000e+00 -5.1654304e+01 -1.4141539e+00 +56 9.90000e+00 -5.1399756e+01 -1.4141539e+00 +57 1.00800e+01 -5.1145209e+01 -1.4141539e+00 +58 1.02600e+01 -5.0890661e+01 -1.4141539e+00 +59 1.04400e+01 -5.0636113e+01 -1.4141539e+00 +60 1.06200e+01 -5.0381565e+01 -1.4141539e+00 +61 1.08000e+01 -5.0127018e+01 -1.4141539e+00 +62 1.09800e+01 -4.9872470e+01 -1.4141539e+00 +63 1.11600e+01 -4.9617922e+01 -1.4141539e+00 +64 1.13400e+01 -4.9363375e+01 -1.4141539e+00 +65 1.15200e+01 -4.9108827e+01 -1.4141539e+00 +66 1.17000e+01 -4.8854279e+01 -1.4141539e+00 +67 1.18800e+01 -4.8599732e+01 -1.4141539e+00 +68 1.20600e+01 -4.8345184e+01 -1.4141539e+00 +69 1.22400e+01 -4.8090636e+01 -1.4141539e+00 +70 1.24200e+01 -4.7836088e+01 -1.4141539e+00 +71 1.26000e+01 -4.7581541e+01 -1.4141539e+00 +72 1.27800e+01 -4.7326993e+01 -1.4141539e+00 +73 1.29600e+01 -4.7072445e+01 -1.4141539e+00 +74 1.31400e+01 -4.6817898e+01 -1.4141539e+00 +75 1.33200e+01 -4.6563350e+01 -1.4141539e+00 +76 1.35000e+01 -4.6308802e+01 -1.4141539e+00 +77 1.36800e+01 -4.6054255e+01 -1.4141539e+00 +78 1.38600e+01 -4.5799707e+01 -1.4141539e+00 +79 1.40400e+01 -4.5545159e+01 -1.4141539e+00 +80 1.42200e+01 -4.5290611e+01 -1.4141539e+00 +81 1.44000e+01 -4.5036064e+01 -1.4141539e+00 +82 1.45800e+01 -4.4781516e+01 -1.4141539e+00 +83 1.47600e+01 -4.4526968e+01 -1.4141539e+00 +84 1.49400e+01 -4.4272421e+01 -1.4141539e+00 +85 1.51200e+01 -4.4017873e+01 -1.4141539e+00 +86 1.53000e+01 -4.3763325e+01 -1.4141539e+00 +87 1.54800e+01 -4.3508777e+01 -1.4141539e+00 +88 1.56600e+01 -4.3254230e+01 -1.4141539e+00 +89 1.58400e+01 -4.2999682e+01 -1.4141539e+00 +90 1.60200e+01 -4.2745134e+01 -1.4141539e+00 +91 1.62000e+01 -4.2490587e+01 -1.4141539e+00 +92 1.63800e+01 -4.2236039e+01 -1.4141539e+00 +93 1.65600e+01 -4.1981491e+01 -1.4141539e+00 +94 1.67400e+01 -4.1726944e+01 -1.4141539e+00 +95 1.69200e+01 -4.1472396e+01 -1.4141539e+00 +96 1.71000e+01 -4.1217848e+01 -1.4141539e+00 +97 1.72800e+01 -4.0963300e+01 -1.4141539e+00 +98 1.74600e+01 -4.0708753e+01 -1.4141539e+00 +99 1.76400e+01 -4.0454205e+01 -1.4141539e+00 +100 1.78200e+01 -4.0199657e+01 -1.4141539e+00 +101 1.80000e+01 -3.9945110e+01 -1.4141539e+00 +102 1.81800e+01 -3.9690562e+01 -1.4141539e+00 +103 1.83600e+01 -3.9436014e+01 -1.4141539e+00 +104 1.85400e+01 -3.9181467e+01 -1.4141539e+00 +105 1.87200e+01 -3.8926919e+01 -1.4141539e+00 +106 1.89000e+01 -3.8672371e+01 -1.4141539e+00 +107 1.90800e+01 -3.8417823e+01 -1.4141539e+00 +108 1.92600e+01 -3.8163276e+01 -1.4141539e+00 +109 1.94400e+01 -3.7908728e+01 -1.4141539e+00 +110 1.96200e+01 -3.7654180e+01 -1.4141539e+00 +111 1.98000e+01 -3.7399633e+01 -1.4141539e+00 +112 1.99800e+01 -3.7145085e+01 -1.4141539e+00 +113 2.01600e+01 -3.6890537e+01 -1.4141539e+00 +114 2.03400e+01 -3.6635989e+01 -1.4141539e+00 +115 2.05200e+01 -3.6381442e+01 -1.4141539e+00 +116 2.07000e+01 -3.6126894e+01 -1.4141539e+00 +117 2.08800e+01 -3.5872346e+01 -1.4141539e+00 +118 2.10600e+01 -3.5617799e+01 -1.4141539e+00 +119 2.12400e+01 -3.5363251e+01 -1.4141539e+00 +120 2.14200e+01 -3.5108703e+01 -1.4141539e+00 +121 2.16000e+01 -3.4854156e+01 -1.4141539e+00 +122 2.17800e+01 -3.4599608e+01 -1.4141539e+00 +123 2.19600e+01 -3.4345060e+01 -1.4141539e+00 +124 2.21400e+01 -3.4090512e+01 -1.4141539e+00 +125 2.23200e+01 -3.3835965e+01 -1.4141539e+00 +126 2.25000e+01 -3.3581417e+01 -1.4141539e+00 +127 2.26800e+01 -3.3326869e+01 -1.4141539e+00 +128 2.28600e+01 -3.3072322e+01 -1.4141539e+00 +129 2.30400e+01 -3.2817774e+01 -1.4141539e+00 +130 2.32200e+01 -3.2563226e+01 -1.4141539e+00 +131 2.34000e+01 -3.2308679e+01 -1.4141539e+00 +132 2.35800e+01 -3.2054131e+01 -1.4141539e+00 +133 2.37600e+01 -3.1799583e+01 -1.4141539e+00 +134 2.39400e+01 -3.1545035e+01 -1.4141539e+00 +135 2.41200e+01 -3.1290488e+01 -1.4141539e+00 +136 2.43000e+01 -3.1035940e+01 -1.4141539e+00 +137 2.44800e+01 -3.0781392e+01 -1.4141539e+00 +138 2.46600e+01 -3.0526845e+01 -1.4141539e+00 +139 2.48400e+01 -3.0272297e+01 -1.4141539e+00 +140 2.50200e+01 -3.0017749e+01 -1.4141539e+00 +141 2.52000e+01 -2.9763201e+01 -1.4141539e+00 +142 2.53800e+01 -2.9508654e+01 -1.4141539e+00 +143 2.55600e+01 -2.9254106e+01 -1.4141539e+00 +144 2.57400e+01 -2.8999558e+01 -1.4141539e+00 +145 2.59200e+01 -2.8745011e+01 -1.4141539e+00 +146 2.61000e+01 -2.8490463e+01 -1.4141539e+00 +147 2.62800e+01 -2.8235915e+01 -1.4141539e+00 +148 2.64600e+01 -2.7981368e+01 -1.4141539e+00 +149 2.66400e+01 -2.7726820e+01 -1.4141539e+00 +150 2.68200e+01 -2.7472272e+01 -1.4141539e+00 +151 2.70000e+01 -2.7217724e+01 -1.4141539e+00 +152 2.71800e+01 -2.6963177e+01 -1.4141539e+00 +153 2.73600e+01 -2.6708629e+01 -1.4141539e+00 +154 2.75400e+01 -2.6454081e+01 -1.4141539e+00 +155 2.77200e+01 -2.6199534e+01 -1.4141539e+00 +156 2.79000e+01 -2.5944986e+01 -1.4141539e+00 +157 2.80800e+01 -2.5690438e+01 -1.4141539e+00 +158 2.82600e+01 -2.5435890e+01 -1.4141539e+00 +159 2.84400e+01 -2.5181343e+01 -1.4141539e+00 +160 2.86200e+01 -2.4926795e+01 -1.4141539e+00 +161 2.88000e+01 -2.4672247e+01 -1.4141539e+00 +162 2.89800e+01 -2.4417700e+01 -1.4141539e+00 +163 2.91600e+01 -2.4163152e+01 -1.4141539e+00 +164 2.93400e+01 -2.3908604e+01 -1.4141539e+00 +165 2.95200e+01 -2.3654057e+01 -1.4141539e+00 +166 2.97000e+01 -2.3399509e+01 -1.4141539e+00 +167 2.98800e+01 -2.3144961e+01 -1.4141539e+00 +168 3.00600e+01 -2.2890413e+01 -1.4141539e+00 +169 3.02400e+01 -2.2635866e+01 -1.4141539e+00 +170 3.04200e+01 -2.2381318e+01 -1.4141539e+00 +171 3.06000e+01 -2.2126770e+01 -1.4141539e+00 +172 3.07800e+01 -2.1872223e+01 -1.4141539e+00 +173 3.09600e+01 -2.1617675e+01 -1.4141539e+00 +174 3.11400e+01 -2.1363127e+01 -1.4141539e+00 +175 3.13200e+01 -2.1108580e+01 -1.4141539e+00 +176 3.15000e+01 -2.0854032e+01 -1.4141539e+00 +177 3.16800e+01 -2.0599484e+01 -1.4141539e+00 +178 3.18600e+01 -2.0344936e+01 -1.4141539e+00 +179 3.20400e+01 -2.0090389e+01 -1.4141539e+00 +180 3.22200e+01 -1.9835841e+01 -1.4141539e+00 +181 3.24000e+01 -1.9581293e+01 -1.4141539e+00 +182 3.25800e+01 -1.9326746e+01 -1.4141539e+00 +183 3.27600e+01 -1.9072198e+01 -1.4141539e+00 +184 3.29400e+01 -1.8817650e+01 -1.4141539e+00 +185 3.31200e+01 -1.8563102e+01 -1.4141539e+00 +186 3.33000e+01 -1.8308555e+01 -1.4141539e+00 +187 3.34800e+01 -1.8054007e+01 -1.4141539e+00 +188 3.36600e+01 -1.7799459e+01 -1.4141539e+00 +189 3.38400e+01 -1.7544912e+01 -1.4141539e+00 +190 3.40200e+01 -1.7290364e+01 -1.4141539e+00 +191 3.42000e+01 -1.7035816e+01 -1.4141539e+00 +192 3.43800e+01 -1.6781269e+01 -1.4141539e+00 +193 3.45600e+01 -1.6526721e+01 -1.4141539e+00 +194 3.47400e+01 -1.6272173e+01 -1.4141539e+00 +195 3.49200e+01 -1.6017625e+01 -1.4141539e+00 +196 3.51000e+01 -1.5763078e+01 -1.4141539e+00 +197 3.52800e+01 -1.5508530e+01 -1.4141539e+00 +198 3.54600e+01 -1.5253982e+01 -1.4141539e+00 +199 3.56400e+01 -1.4999435e+01 -1.4141539e+00 +200 3.58200e+01 -1.4744887e+01 -1.4141539e+00 +201 3.60000e+01 -1.4490339e+01 -1.4141539e+00 +202 3.61800e+01 -1.4235792e+01 -1.4141539e+00 +203 3.63600e+01 -1.3981244e+01 -1.4141539e+00 +204 3.65400e+01 -1.3726696e+01 -1.4141539e+00 +205 3.67200e+01 -1.3472148e+01 -1.4141539e+00 +206 3.69000e+01 -1.3217601e+01 -1.4141539e+00 +207 3.70800e+01 -1.2963053e+01 -1.4141539e+00 +208 3.72600e+01 -1.2708505e+01 -1.4141539e+00 +209 3.74400e+01 -1.2453958e+01 -1.4141539e+00 +210 3.76200e+01 -1.2199410e+01 -1.4141539e+00 +211 3.78000e+01 -1.1944862e+01 -1.4141539e+00 +212 3.79800e+01 -1.1690314e+01 -1.4141539e+00 +213 3.81600e+01 -1.1435767e+01 -1.4141539e+00 +214 3.83400e+01 -1.1181219e+01 -1.4141539e+00 +215 3.85200e+01 -1.0926671e+01 -1.4141539e+00 +216 3.87000e+01 -1.0672124e+01 -1.4141539e+00 +217 3.88800e+01 -1.0417576e+01 -1.4141539e+00 +218 3.90600e+01 -1.0163028e+01 -1.4141539e+00 +219 3.92400e+01 -9.9084806e+00 -1.4141539e+00 +220 3.94200e+01 -9.6539329e+00 -1.4141539e+00 +221 3.96000e+01 -9.3993852e+00 -1.4141539e+00 +222 3.97800e+01 -9.1448374e+00 -1.4141539e+00 +223 3.99600e+01 -8.8902897e+00 -1.4141539e+00 +224 4.01400e+01 -8.6357420e+00 -1.4141539e+00 +225 4.03200e+01 -8.3811943e+00 -1.4141539e+00 +226 4.05000e+01 -8.1266466e+00 -1.4141539e+00 +227 4.06800e+01 -7.8720989e+00 -1.4141539e+00 +228 4.08600e+01 -7.6175512e+00 -1.4141539e+00 +229 4.10400e+01 -7.3630035e+00 -1.4141539e+00 +230 4.12200e+01 -7.1084558e+00 -1.4141539e+00 +231 4.14000e+01 -6.8539081e+00 -1.4141539e+00 +232 4.15800e+01 -6.5993604e+00 -1.4141539e+00 +233 4.17600e+01 -6.3451123e+00 -1.4116569e+00 +234 4.19400e+01 -6.0913137e+00 -1.4087437e+00 +235 4.21200e+01 -5.8381144e+00 -1.4049982e+00 +236 4.23000e+01 -5.5856642e+00 -1.4004204e+00 +237 4.24800e+01 -5.3341129e+00 -1.3950102e+00 +238 4.26600e+01 -5.0836104e+00 -1.3887676e+00 +239 4.28400e+01 -4.8343064e+00 -1.3816928e+00 +240 4.30200e+01 -4.5863508e+00 -1.3737856e+00 +241 4.32000e+01 -4.3398934e+00 -1.3650460e+00 +242 4.33800e+01 -4.0950840e+00 -1.3554741e+00 +243 4.35600e+01 -3.8520725e+00 -1.3450699e+00 +244 4.37400e+01 -3.6110087e+00 -1.3338334e+00 +245 4.39200e+01 -3.3720423e+00 -1.3217645e+00 +246 4.41000e+01 -3.1353233e+00 -1.3088632e+00 +247 4.42800e+01 -2.9010014e+00 -1.2951297e+00 +248 4.44600e+01 -2.6692264e+00 -1.2805638e+00 +249 4.46400e+01 -2.4401483e+00 -1.2651655e+00 +250 4.48200e+01 -2.2139167e+00 -1.2489349e+00 +251 4.50000e+01 -1.9906815e+00 -1.2318720e+00 +252 4.51800e+01 -1.7705926e+00 -1.2139768e+00 +253 4.53600e+01 -1.5537997e+00 -1.1952492e+00 +254 4.55400e+01 -1.3404527e+00 -1.1756892e+00 +255 4.57200e+01 -1.1307014e+00 -1.1552970e+00 +256 4.59000e+01 -9.2469562e-01 -1.1340723e+00 +257 4.60800e+01 -7.2258518e-01 -1.1120154e+00 +258 4.62600e+01 -5.2451990e-01 -1.0891261e+00 +259 4.64400e+01 -3.3064960e-01 -1.0654045e+00 +260 4.66200e+01 -1.4112410e-01 -1.0408503e+00 +261 4.68000e+01 4.3906773e-02 -1.0153760e+00 +262 4.69800e+01 2.2429340e-01 -9.8902709e-01 +263 4.71600e+01 3.9995134e-01 -9.6270864e-01 +264 4.73400e+01 5.7095483e-01 -9.3709040e-01 +265 4.75200e+01 7.3740183e-01 -9.1204860e-01 +266 4.77000e+01 8.9939028e-01 -8.8755096e-01 +267 4.78800e+01 1.0570181e+00 -8.6359746e-01 +268 4.80600e+01 1.2103833e+00 -8.4018812e-01 +269 4.82400e+01 1.3595838e+00 -8.1732293e-01 +270 4.84200e+01 1.5047175e+00 -7.9500187e-01 +271 4.86000e+01 1.6458824e+00 -7.7322498e-01 +272 4.87800e+01 1.7831764e+00 -7.5199223e-01 +273 4.89600e+01 1.9166976e+00 -7.3130363e-01 +274 4.91400e+01 2.0465437e+00 -7.1115919e-01 +275 4.93200e+01 2.1728128e+00 -6.9155888e-01 +276 4.95000e+01 2.2956028e+00 -6.7250272e-01 +277 4.96800e+01 2.4150117e+00 -6.5399073e-01 +278 4.98600e+01 2.5311375e+00 -6.3602289e-01 +279 5.00400e+01 2.6440779e+00 -6.1859916e-01 +280 5.02200e+01 2.7539311e+00 -6.0171962e-01 +281 5.04000e+01 2.8607949e+00 -5.8538422e-01 +282 5.05800e+01 2.9647674e+00 -5.6959295e-01 +283 5.07600e+01 3.0659463e+00 -5.5434585e-01 +284 5.09400e+01 3.1644298e+00 -5.3964290e-01 +285 5.11200e+01 3.2603157e+00 -5.2548408e-01 +286 5.13000e+01 3.3537020e+00 -5.1186943e-01 +287 5.14800e+01 3.4446867e+00 -4.9879893e-01 +288 5.16600e+01 3.5333676e+00 -4.8627255e-01 +289 5.18400e+01 3.6198427e+00 -4.7429035e-01 +290 5.20200e+01 3.7042101e+00 -4.6285229e-01 +291 5.22000e+01 3.7865675e+00 -4.5195837e-01 +292 5.23800e+01 3.8670130e+00 -4.4161003e-01 +293 5.25600e+01 3.9456446e+00 -4.3188395e-01 +294 5.27400e+01 4.0225591e+00 -4.2265255e-01 +295 5.29200e+01 4.0977975e+00 -4.1334526e-01 +296 5.31000e+01 4.1713149e+00 -4.0364940e-01 +297 5.32800e+01 4.2430591e+00 -3.9365327e-01 +298 5.34600e+01 4.3129779e+00 -3.8336719e-01 +299 5.36400e+01 4.3810191e+00 -3.7279118e-01 +300 5.38200e+01 4.4471306e+00 -3.6192527e-01 +301 5.40000e+01 4.5112600e+00 -3.5076941e-01 +302 5.41800e+01 4.5733554e+00 -3.3932361e-01 +303 5.43600e+01 4.6333643e+00 -3.2758791e-01 +304 5.45400e+01 4.6912348e+00 -3.1556227e-01 +305 5.47200e+01 4.7469146e+00 -3.0324669e-01 +306 5.49000e+01 4.8003514e+00 -2.9064119e-01 +307 5.50800e+01 4.8514932e+00 -2.7774577e-01 +308 5.52600e+01 4.9002877e+00 -2.6456043e-01 +309 5.54400e+01 4.9466828e+00 -2.5108513e-01 +310 5.56200e+01 4.9906262e+00 -2.3731992e-01 +311 5.58000e+01 5.0320658e+00 -2.2326479e-01 +312 5.59800e+01 5.0709493e+00 -2.0891973e-01 +313 5.61600e+01 5.1072247e+00 -1.9428474e-01 +314 5.63400e+01 5.1408396e+00 -1.7935982e-01 +315 5.65200e+01 5.1717420e+00 -1.6414496e-01 +316 5.67000e+01 5.1998796e+00 -1.4864017e-01 +317 5.68800e+01 5.2252003e+00 -1.3284549e-01 +318 5.70600e+01 5.2476518e+00 -1.1676084e-01 +319 5.72400e+01 5.2671820e+00 -1.0038629e-01 +320 5.74200e+01 5.2837387e+00 -8.3721799e-02 +321 5.76000e+01 5.2972697e+00 -6.6767354e-02 +322 5.77800e+01 5.3077228e+00 -4.9523048e-02 +323 5.79600e+01 5.3150458e+00 -3.1988751e-02 +324 5.81400e+01 5.3191865e+00 -1.4158719e-02 +325 5.83200e+01 5.3200928e+00 4.0811116e-03 +326 5.85000e+01 5.3177168e+00 2.2451136e-02 +327 5.86800e+01 5.3121051e+00 4.0169275e-02 +328 5.88600e+01 5.3033977e+00 5.6973873e-02 +329 5.90400e+01 5.2917382e+00 7.2974824e-02 +330 5.92200e+01 5.2772705e+00 8.8177269e-02 +331 5.94000e+01 5.2601381e+00 1.0258120e-01 +332 5.95800e+01 5.2404850e+00 1.1618669e-01 +333 5.97600e+01 5.2184547e+00 1.2899368e-01 +334 5.99400e+01 5.1941910e+00 1.4100213e-01 +335 6.01200e+01 5.1678376e+00 1.5221210e-01 +336 6.03000e+01 5.1395383e+00 1.6262367e-01 +337 6.04800e+01 5.1094368e+00 1.7223669e-01 +338 6.06600e+01 5.0776769e+00 1.8105113e-01 +339 6.08400e+01 5.0444021e+00 1.8906726e-01 +340 6.10200e+01 5.0097564e+00 1.9628480e-01 +341 6.12000e+01 4.9738834e+00 2.0270376e-01 +342 6.13800e+01 4.9369268e+00 2.0832442e-01 +343 6.15600e+01 4.8990303e+00 2.1314649e-01 +344 6.17400e+01 4.8603377e+00 2.1717002e-01 +345 6.19200e+01 4.8209928e+00 2.2039510e-01 +346 6.21000e+01 4.7811392e+00 2.2282179e-01 +347 6.22800e+01 4.7409207e+00 2.2444986e-01 +348 6.24600e+01 4.7004810e+00 2.2499622e-01 +349 6.26400e+01 4.6599638e+00 2.2499623e-01 +350 6.28200e+01 4.6195129e+00 2.2454334e-01 +351 6.30000e+01 4.5792720e+00 2.2297736e-01 +352 6.31800e+01 4.5393848e+00 2.2061311e-01 +353 6.33600e+01 4.4999950e+00 2.1745030e-01 +354 6.35400e+01 4.4612464e+00 2.1348890e-01 +355 6.37200e+01 4.4232827e+00 2.0872912e-01 +356 6.39000e+01 4.3862476e+00 2.0316042e-01 +357 6.40800e+01 4.3502849e+00 1.9668922e-01 +358 6.42600e+01 4.3155297e+00 1.8964640e-01 +359 6.44400e+01 4.2820197e+00 1.8270549e-01 +360 6.46200e+01 4.2497320e+00 1.7598157e-01 +361 6.48000e+01 4.2186422e+00 1.6939308e-01 +362 6.49800e+01 4.1887263e+00 1.6293898e-01 +363 6.51600e+01 4.1599600e+00 1.5661902e-01 +364 6.53400e+01 4.1323193e+00 1.5043324e-01 +365 6.55200e+01 4.1057799e+00 1.4438173e-01 +366 6.57000e+01 4.0803177e+00 1.3846450e-01 +367 6.58800e+01 4.0559085e+00 1.3268145e-01 +368 6.60600e+01 4.0325282e+00 1.2703254e-01 +369 6.62400e+01 4.0101527e+00 1.2151800e-01 +370 6.64200e+01 3.9887576e+00 1.1613761e-01 +371 6.66000e+01 3.9683190e+00 1.1089139e-01 +372 6.67800e+01 3.9488125e+00 1.0577952e-01 +373 6.69600e+01 3.9302142e+00 1.0080180e-01 +374 6.71400e+01 3.9124997e+00 9.5958273e-02 +375 6.73200e+01 3.8956450e+00 9.1249023e-02 +376 6.75000e+01 3.8796259e+00 8.6674023e-02 +377 6.76800e+01 3.8644182e+00 8.2233193e-02 +378 6.78600e+01 3.8499978e+00 7.7926573e-02 +379 6.80400e+01 3.8363405e+00 7.3754253e-02 +380 6.82200e+01 3.8234221e+00 6.9716094e-02 +381 6.84000e+01 3.8112185e+00 6.5812157e-02 +382 6.85800e+01 3.7997056e+00 6.2042498e-02 +383 6.87600e+01 3.7888591e+00 5.8407027e-02 +384 6.89400e+01 3.7786549e+00 5.4905770e-02 +385 6.91200e+01 3.7690688e+00 5.1538755e-02 +386 6.93000e+01 3.7600768e+00 4.8305968e-02 +387 6.94800e+01 3.7516545e+00 4.5207408e-02 +388 6.96600e+01 3.7437780e+00 4.2240286e-02 +389 6.98400e+01 3.7364229e+00 3.9394893e-02 +390 7.00200e+01 3.7295632e+00 3.6725615e-02 +391 7.02000e+01 3.7231608e+00 3.4299208e-02 +392 7.03800e+01 3.7171724e+00 3.2118193e-02 +393 7.05600e+01 3.7115552e+00 3.0176466e-02 +394 7.07400e+01 3.7062658e+00 2.8474044e-02 +395 7.09200e+01 3.7012614e+00 2.7010954e-02 +396 7.11000e+01 3.6964988e+00 2.5787161e-02 +397 7.12800e+01 3.6919350e+00 2.4802661e-02 +398 7.14600e+01 3.6875268e+00 2.4057474e-02 +399 7.16400e+01 3.6832312e+00 2.3551614e-02 +400 7.18200e+01 3.6790051e+00 2.3359584e-02 +401 7.20000e+01 3.6748055e+00 2.3359584e-02 +402 7.21800e+01 3.6705893e+00 2.3469823e-02 +403 7.23600e+01 3.6663133e+00 2.3921155e-02 +404 7.25400e+01 3.6619346e+00 2.4611803e-02 +405 7.27200e+01 3.6574100e+00 2.5541761e-02 +406 7.29000e+01 3.6526965e+00 2.6711050e-02 +407 7.30800e+01 3.6477509e+00 2.8119632e-02 +408 7.32600e+01 3.6425303e+00 2.9767477e-02 +409 7.34400e+01 3.6369916e+00 3.1654688e-02 +410 7.36200e+01 3.6310916e+00 3.3781187e-02 +411 7.38000e+01 3.6247873e+00 3.6146962e-02 +412 7.39800e+01 3.6180356e+00 3.8752091e-02 +413 7.41600e+01 3.6107934e+00 4.1596510e-02 +414 7.43400e+01 3.6030178e+00 4.4680221e-02 +415 7.45200e+01 3.5946655e+00 4.8003226e-02 +416 7.47000e+01 3.5856935e+00 5.1565583e-02 +417 7.48800e+01 3.5760588e+00 5.5367233e-02 +418 7.50600e+01 3.5657182e+00 5.9408132e-02 +419 7.52400e+01 3.5546288e+00 6.3688423e-02 +420 7.54200e+01 3.5427473e+00 6.8223879e-02 +421 7.56000e+01 3.5300308e+00 7.3029965e-02 +422 7.57800e+01 3.5164482e+00 7.7880892e-02 +423 7.59600e+01 3.5020142e+00 8.2553868e-02 +424 7.61400e+01 3.4867546e+00 8.7068515e-02 +425 7.63200e+01 3.4706953e+00 9.1439765e-02 +426 7.65000e+01 3.4538621e+00 9.5667672e-02 +427 7.66800e+01 3.4362808e+00 9.9752176e-02 +428 7.68600e+01 3.4179771e+00 1.0369322e-01 +429 7.70400e+01 3.3989770e+00 1.0749097e-01 +430 7.72200e+01 3.3793062e+00 1.1114530e-01 +431 7.74000e+01 3.3589905e+00 1.1465616e-01 +432 7.75800e+01 3.3380558e+00 1.1802375e-01 +433 7.77600e+01 3.3165278e+00 1.2124790e-01 +434 7.79400e+01 3.2944323e+00 1.2432860e-01 +435 7.81200e+01 3.2717953e+00 1.2726596e-01 +436 7.83000e+01 3.2486424e+00 1.3005998e-01 +437 7.84800e+01 3.2249995e+00 1.3271057e-01 +438 7.86600e+01 3.2008924e+00 1.3521770e-01 +439 7.88400e+01 3.1763469e+00 1.3758155e-01 +440 7.90200e+01 3.1513889e+00 1.3980196e-01 +441 7.92000e+01 3.1260440e+00 1.4187893e-01 +442 7.93800e+01 3.1003383e+00 1.4381262e-01 +443 7.95600e+01 3.0742973e+00 1.4560284e-01 +444 7.97400e+01 3.0479470e+00 1.4724966e-01 +445 7.99200e+01 3.0213132e+00 1.4875311e-01 +446 8.01000e+01 2.9944217e+00 1.5011321e-01 +447 8.02800e+01 2.9672983e+00 1.5132989e-01 +448 8.04600e+01 2.9399688e+00 1.5240312e-01 +449 8.06400e+01 2.9124590e+00 1.5333308e-01 +450 8.08200e+01 2.8847947e+00 1.5411956e-01 +451 8.10000e+01 2.8570018e+00 1.5476259e-01 +452 8.11800e+01 2.8291059e+00 1.5525096e-01 +453 8.13600e+01 2.8011331e+00 1.5559419e-01 +454 8.15400e+01 2.7731025e+00 1.5588274e-01 +455 8.17200e+01 2.7450184e+00 1.5617122e-01 +456 8.19000e+01 2.7168829e+00 1.5645093e-01 +457 8.20800e+01 2.6886982e+00 1.5671895e-01 +458 8.22600e+01 2.6604662e+00 1.5697527e-01 +459 8.24400e+01 2.6321891e+00 1.5722007e-01 +460 8.26200e+01 2.6038691e+00 1.5745319e-01 +461 8.28000e+01 2.5755081e+00 1.5767458e-01 +462 8.29800e+01 2.5471083e+00 1.5788447e-01 +463 8.31600e+01 2.5186718e+00 1.5808266e-01 +464 8.33400e+01 2.4902007e+00 1.5826915e-01 +465 8.35200e+01 2.4616970e+00 1.5844407e-01 +466 8.37000e+01 2.4331629e+00 1.5860740e-01 +467 8.38800e+01 2.4046004e+00 1.5875902e-01 +468 8.40600e+01 2.3760117e+00 1.5889896e-01 +469 8.42400e+01 2.3473989e+00 1.5902738e-01 +470 8.44200e+01 2.3187640e+00 1.5914408e-01 +471 8.46000e+01 2.2901091e+00 1.5924910e-01 +472 8.47800e+01 2.2614364e+00 1.5934261e-01 +473 8.49600e+01 2.2327479e+00 1.5942440e-01 +474 8.51400e+01 2.2040457e+00 1.5949452e-01 +475 8.53200e+01 2.1753319e+00 1.5955304e-01 +476 8.55000e+01 2.1466087e+00 1.5959998e-01 +477 8.56800e+01 2.1178780e+00 1.5963520e-01 +478 8.58600e+01 2.0891421e+00 1.5965876e-01 +479 8.60400e+01 2.0604030e+00 1.5966658e-01 +480 8.62200e+01 2.0316627e+00 1.5966658e-01 +481 8.64000e+01 2.0029235e+00 1.5965974e-01 +482 8.65800e+01 1.9741873e+00 1.5963685e-01 +483 8.67600e+01 1.9454563e+00 1.5960227e-01 +484 8.69400e+01 1.9167326e+00 1.5955568e-01 +485 8.71200e+01 1.8880182e+00 1.5949769e-01 +486 8.73000e+01 1.8593151e+00 1.5943103e-01 +487 8.74800e+01 1.8306245e+00 1.5935722e-01 +488 8.76600e+01 1.8019478e+00 1.5927573e-01 +489 8.78400e+01 1.7732866e+00 1.5918672e-01 +490 8.80200e+01 1.7446420e+00 1.5908999e-01 +491 8.82000e+01 1.7160156e+00 1.5898553e-01 +492 8.83800e+01 1.6874086e+00 1.5887355e-01 +493 8.85600e+01 1.6588225e+00 1.5875385e-01 +494 8.87400e+01 1.6302586e+00 1.5862645e-01 +495 8.89200e+01 1.6017183e+00 1.5849144e-01 +496 8.91000e+01 1.5732030e+00 1.5834881e-01 +497 8.92800e+01 1.5447141e+00 1.5819849e-01 +498 8.94600e+01 1.5162530e+00 1.5804046e-01 +499 8.96400e+01 1.4878209e+00 1.5787488e-01 +500 8.98200e+01 1.4594194e+00 1.5770159e-01 +501 9.00000e+01 1.4310497e+00 1.5752059e-01 +502 9.01800e+01 1.4027133e+00 1.5733204e-01 +503 9.03600e+01 1.3744116e+00 1.5713579e-01 +504 9.05400e+01 1.3461458e+00 1.5693182e-01 +505 9.07200e+01 1.3179175e+00 1.5672026e-01 +506 9.09000e+01 1.2897279e+00 1.5650109e-01 +507 9.10800e+01 1.2615785e+00 1.5627421e-01 +508 9.12600e+01 1.2334706e+00 1.5603961e-01 +509 9.14400e+01 1.2054056e+00 1.5579748e-01 +510 9.16200e+01 1.1773849e+00 1.5554764e-01 +511 9.18000e+01 1.1494098e+00 1.5529008e-01 +512 9.19800e+01 1.1214818e+00 1.5502498e-01 +513 9.21600e+01 1.0936022e+00 1.5475216e-01 +514 9.23400e+01 1.0657724e+00 1.5447165e-01 +515 9.25200e+01 1.0379938e+00 1.5418356e-01 +516 9.27000e+01 1.0102677e+00 1.5388859e-01 +517 9.28800e+01 9.8259561e-01 1.5358487e-01 +518 9.30600e+01 9.5497945e-01 1.5326767e-01 +519 9.32400e+01 9.2742181e-01 1.5293549e-01 +520 9.34200e+01 8.9992526e-01 1.5258888e-01 +521 9.36000e+01 8.7249240e-01 1.5222786e-01 +522 9.37800e+01 8.4512580e-01 1.5185262e-01 +523 9.39600e+01 8.1782804e-01 1.5146298e-01 +524 9.41400e+01 7.9060172e-01 1.5105894e-01 +525 9.43200e+01 7.6344940e-01 1.5064060e-01 +526 9.45000e+01 7.3637368e-01 1.5020796e-01 +527 9.46800e+01 7.0937712e-01 1.4976094e-01 +528 9.48600e+01 6.8246233e-01 1.4929951e-01 +529 9.50400e+01 6.5563187e-01 1.4882385e-01 +530 9.52200e+01 6.2888833e-01 1.4833379e-01 +531 9.54000e+01 6.0223430e-01 1.4782932e-01 +532 9.55800e+01 5.7567235e-01 1.4731063e-01 +533 9.57600e+01 5.4920506e-01 1.4677753e-01 +534 9.59400e+01 5.2283502e-01 1.4623004e-01 +535 9.61200e+01 4.9656482e-01 1.4566826e-01 +536 9.63000e+01 4.7039703e-01 1.4509217e-01 +537 9.64800e+01 4.4433422e-01 1.4450170e-01 +538 9.66600e+01 4.1837900e-01 1.4389682e-01 +539 9.68400e+01 3.9253394e-01 1.4327771e-01 +540 9.70200e+01 3.6680161e-01 1.4264420e-01 +541 9.72000e+01 3.4118462e-01 1.4199628e-01 +542 9.73800e+01 3.1568553e-01 1.4133414e-01 +543 9.75600e+01 2.9030691e-01 1.4065759e-01 +544 9.77400e+01 2.6505138e-01 1.3996665e-01 +545 9.79200e+01 2.3992150e-01 1.3926142e-01 +546 9.81000e+01 2.1491985e-01 1.3854188e-01 +547 9.82800e+01 1.9004901e-01 1.3780795e-01 +548 9.84600e+01 1.6531157e-01 1.3705966e-01 +549 9.86400e+01 1.4071012e-01 1.3629706e-01 +550 9.88200e+01 1.1624725e-01 1.3551985e-01 +551 9.90000e+01 9.1925599e-02 1.3472800e-01 +552 9.91800e+01 6.7747784e-02 1.3392168e-01 +553 9.93600e+01 4.3716420e-02 1.3310075e-01 +554 9.95400e+01 1.9834143e-02 1.3226519e-01 +555 9.97200e+01 -3.8964316e-03 1.3141512e-01 +556 9.99000e+01 -2.7472680e-02 1.3055051e-01 +557 1.00080e+02 -5.0891989e-02 1.2967129e-01 +558 1.00260e+02 -7.4151719e-02 1.2877745e-01 +559 1.00440e+02 -9.7249257e-02 1.2786915e-01 +560 1.00620e+02 -1.2018199e-01 1.2694622e-01 +561 1.00800e+02 -1.4294727e-01 1.2600867e-01 +562 1.00980e+02 -1.6554249e-01 1.2505666e-01 +563 1.01160e+02 -1.8796504e-01 1.2409002e-01 +564 1.01340e+02 -2.1021227e-01 1.2310877e-01 +565 1.01520e+02 -2.3228158e-01 1.2211300e-01 +566 1.01700e+02 -2.5417034e-01 1.2110269e-01 +567 1.01880e+02 -2.7587592e-01 1.2007778e-01 +568 1.02060e+02 -2.9739571e-01 1.1903825e-01 +569 1.02240e+02 -3.1872708e-01 1.1798424e-01 +570 1.02420e+02 -3.3986741e-01 1.1691561e-01 +571 1.02600e+02 -3.6081407e-01 1.1583237e-01 +572 1.02780e+02 -3.8156445e-01 1.1473465e-01 +573 1.02960e+02 -4.0211592e-01 1.1362232e-01 +574 1.03140e+02 -4.2246586e-01 1.1249538e-01 +575 1.03320e+02 -4.4261164e-01 1.1135391e-01 +576 1.03500e+02 -4.6255064e-01 1.1019790e-01 +577 1.03680e+02 -4.8228026e-01 1.0902729e-01 +578 1.03860e+02 -5.0179784e-01 1.0784206e-01 +579 1.04040e+02 -5.2110078e-01 1.0664221e-01 +580 1.04220e+02 -5.4018647e-01 1.0542714e-01 +581 1.04400e+02 -5.5905236e-01 1.0419964e-01 +582 1.04580e+02 -5.7769659e-01 1.0296342e-01 +583 1.04760e+02 -5.9611756e-01 1.0171847e-01 +584 1.04940e+02 -6.1431362e-01 1.0046448e-01 +585 1.05120e+02 -6.3228315e-01 9.9201492e-02 +586 1.05300e+02 -6.5002453e-01 9.7929512e-02 +587 1.05480e+02 -6.6753615e-01 9.6648481e-02 +588 1.05660e+02 -6.8481636e-01 9.5358391e-02 +589 1.05840e+02 -7.0186355e-01 9.4059355e-02 +590 1.06020e+02 -7.1867610e-01 9.2751257e-02 +591 1.06200e+02 -7.3525238e-01 9.1434101e-02 +592 1.06380e+02 -7.5159076e-01 9.0107998e-02 +593 1.06560e+02 -7.6768963e-01 8.8772834e-02 +594 1.06740e+02 -7.8354735e-01 8.7428622e-02 +595 1.06920e+02 -7.9916231e-01 8.6075416e-02 +596 1.07100e+02 -8.1453288e-01 8.4713213e-02 +597 1.07280e+02 -8.2965744e-01 8.3341966e-02 +598 1.07460e+02 -8.4453436e-01 8.1961658e-02 +599 1.07640e+02 -8.5916202e-01 8.0572396e-02 +600 1.07820e+02 -8.7353880e-01 7.9174081e-02 +601 1.08000e+02 -8.8766306e-01 7.7766710e-02 +602 1.08180e+02 -9.0153319e-01 7.6350381e-02 +603 1.08360e+02 -9.1514757e-01 7.4924999e-02 +604 1.08540e+02 -9.2850457e-01 7.3490572e-02 +605 1.08720e+02 -9.4160256e-01 7.2047146e-02 +606 1.08900e+02 -9.5443992e-01 7.0594719e-02 +607 1.09080e+02 -9.6701503e-01 6.9133250e-02 +608 1.09260e+02 -9.7932626e-01 6.7662732e-02 +609 1.09440e+02 -9.9137199e-01 6.6183242e-02 +610 1.09620e+02 -1.0031506e+00 6.4694710e-02 +611 1.09800e+02 -1.0146605e+00 6.3196356e-02 +612 1.09980e+02 -1.0258999e+00 6.1687720e-02 +613 1.10160e+02 -1.0368680e+00 6.0178958e-02 +614 1.10340e+02 -1.0475656e+00 5.8679814e-02 +615 1.10520e+02 -1.0579942e+00 5.7189432e-02 +616 1.10700e+02 -1.0681552e+00 5.5707154e-02 +617 1.10880e+02 -1.0780502e+00 5.4232947e-02 +618 1.11060e+02 -1.0876806e+00 5.2766814e-02 +619 1.11240e+02 -1.0970477e+00 5.1308811e-02 +620 1.11420e+02 -1.1061532e+00 4.9858868e-02 +621 1.11600e+02 -1.1149984e+00 4.8417006e-02 +622 1.11780e+02 -1.1235848e+00 4.6983272e-02 +623 1.11960e+02 -1.1319138e+00 4.5557597e-02 +624 1.12140e+02 -1.1399870e+00 4.4140014e-02 +625 1.12320e+02 -1.1478057e+00 4.2730528e-02 +626 1.12500e+02 -1.1553714e+00 4.1329140e-02 +627 1.12680e+02 -1.1626856e+00 3.9935837e-02 +628 1.12860e+02 -1.1697498e+00 3.8550600e-02 +629 1.13040e+02 -1.1765653e+00 3.7173492e-02 +630 1.13220e+02 -1.1831337e+00 3.5804457e-02 +631 1.13400e+02 -1.1894564e+00 3.4443490e-02 +632 1.13580e+02 -1.1955348e+00 3.3090646e-02 +633 1.13760e+02 -1.2013704e+00 3.1745881e-02 +634 1.13940e+02 -1.2069648e+00 3.0409192e-02 +635 1.14120e+02 -1.2123192e+00 2.9080603e-02 +636 1.14300e+02 -1.2174352e+00 2.7760113e-02 +637 1.14480e+02 -1.2223143e+00 2.6447704e-02 +638 1.14660e+02 -1.2269579e+00 2.5143376e-02 +639 1.14840e+02 -1.2313674e+00 2.3847157e-02 +640 1.15020e+02 -1.2355443e+00 2.2559018e-02 +641 1.15200e+02 -1.2394901e+00 2.1278961e-02 +642 1.15380e+02 -1.2432062e+00 2.0007004e-02 +643 1.15560e+02 -1.2466941e+00 1.8742761e-02 +644 1.15740e+02 -1.2499552e+00 1.7486524e-02 +645 1.15920e+02 -1.2529912e+00 1.6241800e-02 +646 1.16100e+02 -1.2558046e+00 1.5011056e-02 +647 1.16280e+02 -1.2583976e+00 1.3793797e-02 +648 1.16460e+02 -1.2607728e+00 1.2589897e-02 +649 1.16640e+02 -1.2629324e+00 1.1399383e-02 +650 1.16820e+02 -1.2648789e+00 1.0222240e-02 +651 1.17000e+02 -1.2666148e+00 9.0584625e-03 +652 1.17180e+02 -1.2681424e+00 7.9080625e-03 +653 1.17360e+02 -1.2694641e+00 6.7710417e-03 +654 1.17540e+02 -1.2705824e+00 5.6473791e-03 +655 1.17720e+02 -1.2714996e+00 4.5370973e-03 +656 1.17900e+02 -1.2722181e+00 3.4401860e-03 +657 1.18080e+02 -1.2727405e+00 2.3566459e-03 +658 1.18260e+02 -1.2730689e+00 1.2864861e-03 +659 1.18440e+02 -1.2732060e+00 2.2968470e-04 +660 1.18620e+02 -1.2731540e+00 -8.1373748e-04 +661 1.18800e+02 -1.2729155e+00 -1.8437819e-03 +662 1.18980e+02 -1.2724927e+00 -2.8604626e-03 +663 1.19160e+02 -1.2718881e+00 -3.8637638e-03 +664 1.19340e+02 -1.2711041e+00 -4.8536931e-03 +665 1.19520e+02 -1.2701432e+00 -5.8302555e-03 +666 1.19700e+02 -1.2690076e+00 -6.7934459e-03 +667 1.19880e+02 -1.2676999e+00 -7.7432583e-03 +668 1.20060e+02 -1.2662225e+00 -8.6796987e-03 +669 1.20240e+02 -1.2645777e+00 -9.6027750e-03 +670 1.20420e+02 -1.2627679e+00 -1.0512465e-02 +671 1.20600e+02 -1.2607956e+00 -1.1408790e-02 +672 1.20780e+02 -1.2586631e+00 -1.2291749e-02 +673 1.20960e+02 -1.2563730e+00 -1.3161329e-02 +674 1.21140e+02 -1.2539275e+00 -1.4017525e-02 +675 1.21320e+02 -1.2513290e+00 -1.4859989e-02 +676 1.21500e+02 -1.2485801e+00 -1.5689347e-02 +677 1.21680e+02 -1.2456828e+00 -1.6508237e-02 +678 1.21860e+02 -1.2426389e+00 -1.7317985e-02 +679 1.22040e+02 -1.2394501e+00 -1.8118197e-02 +680 1.22220e+02 -1.2361181e+00 -1.8908812e-02 +681 1.22400e+02 -1.2326446e+00 -1.9689850e-02 +682 1.22580e+02 -1.2290315e+00 -2.0461318e-02 +683 1.22760e+02 -1.2252803e+00 -2.1223183e-02 +684 1.22940e+02 -1.2213928e+00 -2.1975467e-02 +685 1.23120e+02 -1.2173708e+00 -2.2718178e-02 +686 1.23300e+02 -1.2132160e+00 -2.3451304e-02 +687 1.23480e+02 -1.2089301e+00 -2.4174843e-02 +688 1.23660e+02 -1.2045148e+00 -2.4888790e-02 +689 1.23840e+02 -1.1999719e+00 -2.5593175e-02 +690 1.24020e+02 -1.1953030e+00 -2.6287964e-02 +691 1.24200e+02 -1.1905099e+00 -2.6973156e-02 +692 1.24380e+02 -1.1855944e+00 -2.7648792e-02 +693 1.24560e+02 -1.1805581e+00 -2.8314829e-02 +694 1.24740e+02 -1.1754028e+00 -2.8971279e-02 +695 1.24920e+02 -1.1701301e+00 -2.9618151e-02 +696 1.25100e+02 -1.1647419e+00 -3.0255446e-02 +697 1.25280e+02 -1.1592399e+00 -3.0883151e-02 +698 1.25460e+02 -1.1536257e+00 -3.1501265e-02 +699 1.25640e+02 -1.1479012e+00 -3.2109817e-02 +700 1.25820e+02 -1.1420679e+00 -3.2708771e-02 +701 1.26000e+02 -1.1361277e+00 -3.3298135e-02 +702 1.26180e+02 -1.1300823e+00 -3.3877938e-02 +703 1.26360e+02 -1.1239334e+00 -3.4448137e-02 +704 1.26540e+02 -1.1176827e+00 -3.5008750e-02 +705 1.26720e+02 -1.1113320e+00 -3.5559787e-02 +706 1.26900e+02 -1.1048829e+00 -3.6101243e-02 +707 1.27080e+02 -1.0983373e+00 -3.6632801e-02 +708 1.27260e+02 -1.0916967e+00 -3.7155198e-02 +709 1.27440e+02 -1.0849627e+00 -3.7670333e-02 +710 1.27620e+02 -1.0781366e+00 -3.8178730e-02 +711 1.27800e+02 -1.0712197e+00 -3.8680133e-02 +712 1.27980e+02 -1.0642131e+00 -3.9174585e-02 +713 1.28160e+02 -1.0571181e+00 -3.9662035e-02 +714 1.28340e+02 -1.0499360e+00 -4.0142489e-02 +715 1.28520e+02 -1.0426680e+00 -4.0615960e-02 +716 1.28700e+02 -1.0353155e+00 -4.1082470e-02 +717 1.28880e+02 -1.0278796e+00 -4.1541976e-02 +718 1.29060e+02 -1.0203616e+00 -4.1994469e-02 +719 1.29240e+02 -1.0127628e+00 -4.2440025e-02 +720 1.29420e+02 -1.0050845e+00 -4.2878573e-02 +721 1.29600e+02 -9.9732782e-01 -4.3310116e-02 +722 1.29780e+02 -9.8949410e-01 -4.3734706e-02 +723 1.29960e+02 -9.8158458e-01 -4.4152294e-02 +724 1.30140e+02 -9.7360053e-01 -4.4562883e-02 +725 1.30320e+02 -9.6554320e-01 -4.4966498e-02 +726 1.30500e+02 -9.5741385e-01 -4.5363141e-02 +727 1.30680e+02 -9.4921373e-01 -4.5752786e-02 +728 1.30860e+02 -9.4094411e-01 -4.6135424e-02 +729 1.31040e+02 -9.3260623e-01 -4.6511114e-02 +730 1.31220e+02 -9.2420136e-01 -4.6879800e-02 +731 1.31400e+02 -9.1573076e-01 -4.7241480e-02 +732 1.31580e+02 -9.0719569e-01 -4.7596212e-02 +733 1.31760e+02 -8.9859739e-01 -4.7943937e-02 +734 1.31940e+02 -8.8993713e-01 -4.8284663e-02 +735 1.32120e+02 -8.8121616e-01 -4.8618417e-02 +736 1.32300e+02 -8.7243575e-01 -4.8945202e-02 +737 1.32480e+02 -8.6359715e-01 -4.9264982e-02 +738 1.32660e+02 -8.5470162e-01 -4.9577706e-02 +739 1.32840e+02 -8.4575041e-01 -4.9883053e-02 +740 1.33020e+02 -8.3674475e-01 -5.0182410e-02 +741 1.33200e+02 -8.2768547e-01 -5.0478215e-02 +742 1.33380e+02 -8.1857321e-01 -5.0770926e-02 +743 1.33560e+02 -8.0940856e-01 -5.1060192e-02 +744 1.33740e+02 -8.0019216e-01 -5.1346014e-02 +745 1.33920e+02 -7.9092461e-01 -5.1628425e-02 +746 1.34100e+02 -7.8160654e-01 -5.1907427e-02 +747 1.34280e+02 -7.7223855e-01 -5.2182981e-02 +748 1.34460e+02 -7.6282128e-01 -5.2455089e-02 +749 1.34640e+02 -7.5335534e-01 -5.2723810e-02 +750 1.34820e+02 -7.4384133e-01 -5.2989081e-02 +751 1.35000e+02 -7.3427989e-01 -5.3250905e-02 +752 1.35180e+02 -7.2467162e-01 -5.3509343e-02 +753 1.35360e+02 -7.1501714e-01 -5.3764332e-02 +754 1.35540e+02 -7.0531708e-01 -5.4015876e-02 +755 1.35720e+02 -6.9557204e-01 -5.4264010e-02 +756 1.35900e+02 -6.8578265e-01 -5.4508734e-02 +757 1.36080e+02 -6.7594952e-01 -5.4750010e-02 +758 1.36260e+02 -6.6607326e-01 -5.4987839e-02 +759 1.36440e+02 -6.5615451e-01 -5.5222284e-02 +760 1.36620e+02 -6.4619386e-01 -5.5453277e-02 +761 1.36800e+02 -6.3619195e-01 -5.5680823e-02 +762 1.36980e+02 -6.2614938e-01 -5.5904985e-02 +763 1.37160e+02 -6.1606677e-01 -5.6125695e-02 +764 1.37340e+02 -6.0594475e-01 -5.6342960e-02 +765 1.37520e+02 -5.9578392e-01 -5.6556816e-02 +766 1.37700e+02 -5.8558491e-01 -5.6767263e-02 +767 1.37880e+02 -5.7534832e-01 -5.6974263e-02 +768 1.38060e+02 -5.6507479e-01 -5.7177812e-02 +769 1.38240e+02 -5.5476492e-01 -5.7377979e-02 +770 1.38420e+02 -5.4441934e-01 -5.7574527e-02 +771 1.38600e+02 -5.3403865e-01 -5.7766980e-02 +772 1.38780e+02 -5.2362336e-01 -5.7958495e-02 +773 1.38960e+02 -5.1317326e-01 -5.8152824e-02 +774 1.39140e+02 -5.0268788e-01 -5.8350080e-02 +775 1.39320e+02 -4.9216677e-01 -5.8549940e-02 +776 1.39500e+02 -4.8160944e-01 -5.8752403e-02 +777 1.39680e+02 -4.7101544e-01 -5.8957432e-02 +778 1.39860e+02 -4.6038430e-01 -5.9165021e-02 +779 1.40040e+02 -4.4971556e-01 -5.9375242e-02 +780 1.40220e+02 -4.3900875e-01 -5.9588024e-02 +781 1.40400e+02 -4.2826341e-01 -5.9803368e-02 +782 1.40580e+02 -4.1747907e-01 -6.0021345e-02 +783 1.40760e+02 -4.0665526e-01 -6.0241883e-02 +784 1.40940e+02 -3.9579153e-01 -6.0464983e-02 +785 1.41120e+02 -3.8488740e-01 -6.0690690e-02 +786 1.41300e+02 -3.7394241e-01 -6.0919001e-02 +787 1.41480e+02 -3.6295610e-01 -6.1149876e-02 +788 1.41660e+02 -3.5192799e-01 -6.1383312e-02 +789 1.41840e+02 -3.4085763e-01 -6.1619382e-02 +790 1.42020e+02 -3.2974455e-01 -6.1858011e-02 +791 1.42200e+02 -3.1858829e-01 -6.2099201e-02 +792 1.42380e+02 -3.0738837e-01 -6.2343025e-02 +793 1.42560e+02 -2.9614433e-01 -6.2589409e-02 +794 1.42740e+02 -2.8485572e-01 -6.2838357e-02 +795 1.42920e+02 -2.7352206e-01 -6.3089911e-02 +796 1.43100e+02 -2.6214288e-01 -6.3344069e-02 +797 1.43280e+02 -2.5071773e-01 -6.3600791e-02 +798 1.43460e+02 -2.3924614e-01 -6.3860073e-02 +799 1.43640e+02 -2.2772763e-01 -6.4121991e-02 +800 1.43820e+02 -2.1616176e-01 -6.4386468e-02 +801 1.44000e+02 -2.0454804e-01 -6.4653504e-02 +802 1.44180e+02 -1.9288603e-01 -6.4923496e-02 +803 1.44360e+02 -1.8117524e-01 -6.5196551e-02 +804 1.44540e+02 -1.6941545e-01 -6.5468516e-02 +805 1.44720e+02 -1.5760725e-01 -6.5735587e-02 +806 1.44900e+02 -1.4575140e-01 -6.5998160e-02 +807 1.45080e+02 -1.3384868e-01 -6.6256440e-02 +808 1.45260e+02 -1.2189986e-01 -6.6510420e-02 +809 1.45440e+02 -1.0990570e-01 -6.6760180e-02 +810 1.45620e+02 -9.7866964e-02 -6.7005641e-02 +811 1.45800e+02 -8.5784437e-02 -6.7246802e-02 +812 1.45980e+02 -7.3658880e-02 -6.7483745e-02 +813 1.46160e+02 -6.1491060e-02 -6.7716387e-02 +814 1.46340e+02 -4.9281752e-02 -6.7944735e-02 +815 1.46520e+02 -3.7031722e-02 -6.8168832e-02 +816 1.46700e+02 -2.4741740e-02 -6.8388679e-02 +817 1.46880e+02 -1.2412569e-02 -6.8604230e-02 +818 1.47060e+02 -4.4987875e-05 -6.8815481e-02 +819 1.47240e+02 1.2360239e-02 -6.9022515e-02 +820 1.47420e+02 2.4802346e-02 -6.9225248e-02 +821 1.47600e+02 3.7280557e-02 -6.9423681e-02 +822 1.47780e+02 4.9794106e-02 -6.9617897e-02 +823 1.47960e+02 6.2342229e-02 -6.9807811e-02 +824 1.48140e+02 7.4924147e-02 -6.9993431e-02 +825 1.48320e+02 8.7539097e-02 -7.0174801e-02 +826 1.48500e+02 1.0018631e-01 -7.0351921e-02 +827 1.48680e+02 1.1286502e-01 -7.0524744e-02 +828 1.48860e+02 1.2557445e-01 -7.0693267e-02 +829 1.49040e+02 1.3831383e-01 -7.0857574e-02 +830 1.49220e+02 1.5108240e-01 -7.1017579e-02 +831 1.49400e+02 1.6387939e-01 -7.1173284e-02 +832 1.49580e+02 1.7670402e-01 -7.1324773e-02 +833 1.49760e+02 1.8955553e-01 -7.1471958e-02 +834 1.49940e+02 2.0243315e-01 -7.1614594e-02 +835 1.50120e+02 2.1533611e-01 -7.1752951e-02 +836 1.50300e+02 2.2826383e-01 -7.1889340e-02 +837 1.50480e+02 2.4121610e-01 -7.2025285e-02 +838 1.50660e+02 2.5419278e-01 -7.2160459e-02 +839 1.50840e+02 2.6719372e-01 -7.2294879e-02 +840 1.51020e+02 2.8021879e-01 -7.2428454e-02 +841 1.51200e+02 2.9326782e-01 -7.2561187e-02 +842 1.51380e+02 3.0634067e-01 -7.2693167e-02 +843 1.51560e+02 3.1943721e-01 -7.2824303e-02 +844 1.51740e+02 3.3255727e-01 -7.2954601e-02 +845 1.51920e+02 3.4570072e-01 -7.3084110e-02 +846 1.52100e+02 3.5886741e-01 -7.3212830e-02 +847 1.52280e+02 3.7205719e-01 -7.3340712e-02 +848 1.52460e+02 3.8526992e-01 -7.3467752e-02 +849 1.52640e+02 3.9850544e-01 -7.3594039e-02 +850 1.52820e+02 4.1176362e-01 -7.3719479e-02 +851 1.53000e+02 4.2504431e-01 -7.3844079e-02 +852 1.53180e+02 4.3834735e-01 -7.3967925e-02 +853 1.53360e+02 4.5167261e-01 -7.4090928e-02 +854 1.53540e+02 4.6501994e-01 -7.4213093e-02 +855 1.53720e+02 4.7838918e-01 -7.4334469e-02 +856 1.53900e+02 4.9178020e-01 -7.4455055e-02 +857 1.54080e+02 5.0519285e-01 -7.4574803e-02 +858 1.54260e+02 5.1862698e-01 -7.4693709e-02 +859 1.54440e+02 5.3208244e-01 -7.4811861e-02 +860 1.54620e+02 5.4555910e-01 -7.4929171e-02 +861 1.54800e+02 5.5905680e-01 -7.5045636e-02 +862 1.54980e+02 5.7257539e-01 -7.5161348e-02 +863 1.55160e+02 5.8611473e-01 -7.5276217e-02 +864 1.55340e+02 5.9967468e-01 -7.5390248e-02 +865 1.55520e+02 6.1325508e-01 -7.5503508e-02 +866 1.55700e+02 6.2685579e-01 -7.5616730e-02 +867 1.55880e+02 6.4047666e-01 -7.5728565e-02 +868 1.56060e+02 6.5411696e-01 -7.5833518e-02 +869 1.56240e+02 6.6777523e-01 -7.5929200e-02 +870 1.56420e+02 6.8144994e-01 -7.6016303e-02 +871 1.56600e+02 6.9513957e-01 -7.6094907e-02 +872 1.56780e+02 7.0884259e-01 -7.6165093e-02 +873 1.56960e+02 7.2255747e-01 -7.6226769e-02 +874 1.57140e+02 7.3628270e-01 -7.6279953e-02 +875 1.57320e+02 7.5001673e-01 -7.6324680e-02 +876 1.57500e+02 7.6375806e-01 -7.6360964e-02 +877 1.57680e+02 7.7750515e-01 -7.6388730e-02 +878 1.57860e+02 7.9125648e-01 -7.6408009e-02 +879 1.58040e+02 8.0501051e-01 -7.6417185e-02 +880 1.58220e+02 8.1876574e-01 -7.6417185e-02 +881 1.58400e+02 8.3252062e-01 -7.6415064e-02 +882 1.58580e+02 8.4627364e-01 -7.6400486e-02 +883 1.58760e+02 8.6002327e-01 -7.6377423e-02 +884 1.58940e+02 8.7376799e-01 -7.6345843e-02 +885 1.59120e+02 8.8750625e-01 -7.6305819e-02 +886 1.59300e+02 9.0123656e-01 -7.6257337e-02 +887 1.59480e+02 9.1495737e-01 -7.6200364e-02 +888 1.59660e+02 9.2866716e-01 -7.6134879e-02 +889 1.59840e+02 9.4236440e-01 -7.6060980e-02 +890 1.60020e+02 9.5604758e-01 -7.5978581e-02 +891 1.60200e+02 9.6971516e-01 -7.5887668e-02 +892 1.60380e+02 9.8336562e-01 -7.5788342e-02 +893 1.60560e+02 9.9699744e-01 -7.5680516e-02 +894 1.60740e+02 1.0106091e+00 -7.5564182e-02 +895 1.60920e+02 1.0241990e+00 -7.5439401e-02 +896 1.61100e+02 1.0377657e+00 -7.5306167e-02 +897 1.61280e+02 1.0513077e+00 -7.5164450e-02 +898 1.61460e+02 1.0648234e+00 -7.5014389e-02 +899 1.61640e+02 1.0783113e+00 -7.4855639e-02 +900 1.61820e+02 1.0917697e+00 -7.4687031e-02 +901 1.62000e+02 1.1051968e+00 -7.4508182e-02 +902 1.62180e+02 1.1185908e+00 -7.4319356e-02 +903 1.62360e+02 1.1319500e+00 -7.4120465e-02 +904 1.62540e+02 1.1452724e+00 -7.3911513e-02 +905 1.62720e+02 1.1585563e+00 -7.3692566e-02 +906 1.62900e+02 1.1717999e+00 -7.3463595e-02 +907 1.63080e+02 1.1850014e+00 -7.3224578e-02 +908 1.63260e+02 1.1981590e+00 -7.2975497e-02 +909 1.63440e+02 1.2112708e+00 -7.2716437e-02 +910 1.63620e+02 1.2243351e+00 -7.2447323e-02 +911 1.63800e+02 1.2373500e+00 -7.2168144e-02 +912 1.63980e+02 1.2503138e+00 -7.1878988e-02 +913 1.64160e+02 1.2632246e+00 -7.1579771e-02 +914 1.64340e+02 1.2760807e+00 -7.1270501e-02 +915 1.64520e+02 1.2888802e+00 -7.0951227e-02 +916 1.64700e+02 1.3016214e+00 -7.0621933e-02 +917 1.64880e+02 1.3143023e+00 -7.0282585e-02 +918 1.65060e+02 1.3269213e+00 -6.9933179e-02 +919 1.65240e+02 1.3394765e+00 -6.9573801e-02 +920 1.65420e+02 1.3519660e+00 -6.9204355e-02 +921 1.65600e+02 1.3643882e+00 -6.8824851e-02 +922 1.65780e+02 1.3767412e+00 -6.8435377e-02 +923 1.65960e+02 1.3890231e+00 -6.8035828e-02 +924 1.66140e+02 1.4012323e+00 -6.7626234e-02 +925 1.66320e+02 1.4133668e+00 -6.7206635e-02 +926 1.66500e+02 1.4254249e+00 -6.6777016e-02 +927 1.66680e+02 1.4374047e+00 -6.6337343e-02 +928 1.66860e+02 1.4493045e+00 -6.5887612e-02 +929 1.67040e+02 1.4611224e+00 -6.5428144e-02 +930 1.67220e+02 1.4728567e+00 -6.4960391e-02 +931 1.67400e+02 1.4845054e+00 -6.4478113e-02 +932 1.67580e+02 1.4960648e+00 -6.3970704e-02 +933 1.67760e+02 1.5075302e+00 -6.3436333e-02 +934 1.67940e+02 1.5188972e+00 -6.2876336e-02 +935 1.68120e+02 1.5301611e+00 -6.2290756e-02 +936 1.68300e+02 1.5413173e+00 -6.1679602e-02 +937 1.68480e+02 1.5523612e+00 -6.1042848e-02 +938 1.68660e+02 1.5632881e+00 -6.0380457e-02 +939 1.68840e+02 1.5740935e+00 -5.9692522e-02 +940 1.69020e+02 1.5847728e+00 -5.8978977e-02 +941 1.69200e+02 1.5953213e+00 -5.8239815e-02 +942 1.69380e+02 1.6057345e+00 -5.7475096e-02 +943 1.69560e+02 1.6160078e+00 -5.6684763e-02 +944 1.69740e+02 1.6261364e+00 -5.5868818e-02 +945 1.69920e+02 1.6361159e+00 -5.5027296e-02 +946 1.70100e+02 1.6459417e+00 -5.4160196e-02 +947 1.70280e+02 1.6556090e+00 -5.3267485e-02 +948 1.70460e+02 1.6651133e+00 -5.2349160e-02 +949 1.70640e+02 1.6744501e+00 -5.1405275e-02 +950 1.70820e+02 1.6836146e+00 -5.0435782e-02 +951 1.71000e+02 1.6926024e+00 -4.9440674e-02 +952 1.71180e+02 1.7014087e+00 -4.8420007e-02 +953 1.71360e+02 1.7100290e+00 -4.7373725e-02 +954 1.71540e+02 1.7184586e+00 -4.6301837e-02 +955 1.71720e+02 1.7266930e+00 -4.5204374e-02 +956 1.71900e+02 1.7347276e+00 -4.4081319e-02 +957 1.72080e+02 1.7425577e+00 -4.2932661e-02 +958 1.72260e+02 1.7501787e+00 -4.1758394e-02 +959 1.72440e+02 1.7575861e+00 -4.0558562e-02 +960 1.72620e+02 1.7647752e+00 -3.9333116e-02 +961 1.72800e+02 1.7717414e+00 -3.8080384e-02 +962 1.72980e+02 1.7784801e+00 -3.6795821e-02 +963 1.73160e+02 1.7849880e+00 -3.5510058e-02 +964 1.73340e+02 1.7912686e+00 -3.4260553e-02 +965 1.73520e+02 1.7973278e+00 -3.3047568e-02 +966 1.73700e+02 1.8031717e+00 -3.1867827e-02 +967 1.73880e+02 1.8088062e+00 -3.0721315e-02 +968 1.74060e+02 1.8142373e+00 -2.9608017e-02 +969 1.74240e+02 1.8194711e+00 -2.8527982e-02 +970 1.74420e+02 1.8245134e+00 -2.7481161e-02 +971 1.74600e+02 1.8293703e+00 -2.6467563e-02 +972 1.74780e+02 1.8340477e+00 -2.5487220e-02 +973 1.74960e+02 1.8385516e+00 -2.4540096e-02 +974 1.75140e+02 1.8428881e+00 -2.3626201e-02 +975 1.75320e+02 1.8470630e+00 -2.2745547e-02 +976 1.75500e+02 1.8510825e+00 -2.1898128e-02 +977 1.75680e+02 1.8549524e+00 -2.1083930e-02 +978 1.75860e+02 1.8586787e+00 -2.0302968e-02 +979 1.76040e+02 1.8622674e+00 -1.9555246e-02 +980 1.76220e+02 1.8657245e+00 -1.8840753e-02 +981 1.76400e+02 1.8690561e+00 -1.8159482e-02 +982 1.76580e+02 1.8722679e+00 -1.7511452e-02 +983 1.76760e+02 1.8753662e+00 -1.6896662e-02 +984 1.76940e+02 1.8783567e+00 -1.6315089e-02 +985 1.77120e+02 1.8812456e+00 -1.5766750e-02 +986 1.77300e+02 1.8840387e+00 -1.5251659e-02 +987 1.77480e+02 1.8867422e+00 -1.4769787e-02 +988 1.77660e+02 1.8893618e+00 -1.4321146e-02 +989 1.77840e+02 1.8919037e+00 -1.3905746e-02 +990 1.78020e+02 1.8943739e+00 -1.3523574e-02 +991 1.78200e+02 1.8967782e+00 -1.3174629e-02 +992 1.78380e+02 1.8991227e+00 -1.2858927e-02 +993 1.78560e+02 1.9014134e+00 -1.2576451e-02 +994 1.78740e+02 1.9036562e+00 -1.2327206e-02 +995 1.78920e+02 1.9058572e+00 -1.2111194e-02 +996 1.79100e+02 1.9080222e+00 -1.1928418e-02 +997 1.79280e+02 1.9101574e+00 -1.1778874e-02 +998 1.79460e+02 1.9122686e+00 -1.1662552e-02 +999 1.79640e+02 1.9143619e+00 -1.1579483e-02 +1000 1.79820e+02 1.9164432e+00 -1.1540710e-02 +1001 1.80000e+02 1.9185186e+00 -1.1513008e-02 From b45117655e77697cff3b6ab2f687cb16208be034 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 1 Jun 2022 16:13:45 -0400 Subject: [PATCH 279/585] move patch release date --- doc/lammps.1 | 4 ++-- src/version.h | 2 +- 2 files changed, 3 insertions(+), 3 deletions(-) diff --git a/doc/lammps.1 b/doc/lammps.1 index 51317d8a03..cfeb23aadb 100644 --- a/doc/lammps.1 +++ b/doc/lammps.1 @@ -1,7 +1,7 @@ -.TH LAMMPS "1" "31 May 2022" "2022-5-31" +.TH LAMMPS "1" "2 June 2022" "2022-6-2" .SH NAME .B LAMMPS -\- Molecular Dynamics Simulator. Version 31 May 2022 +\- Molecular Dynamics Simulator. Version 2 June 2022 .SH SYNOPSIS .B lmp diff --git a/src/version.h b/src/version.h index 13ed8f12c4..60ed7ad75f 100644 --- a/src/version.h +++ b/src/version.h @@ -1 +1 @@ -#define LAMMPS_VERSION "31 May 2022" +#define LAMMPS_VERSION "2 Jun 2022" From 4bf90988e2336d5e10fd6ed270d13ef830d201f6 Mon Sep 17 00:00:00 2001 From: Stan Gerald Moore Date: Wed, 1 Jun 2022 14:52:07 -0600 Subject: [PATCH 280/585] Fix bug when comparing equal tags --- src/KOKKOS/pair_reaxff_kokkos.cpp | 33 ++++++++++++++++++++----------- 1 file changed, 21 insertions(+), 12 deletions(-) diff --git a/src/KOKKOS/pair_reaxff_kokkos.cpp b/src/KOKKOS/pair_reaxff_kokkos.cpp index 628241b8bd..7f2477adba 100644 --- a/src/KOKKOS/pair_reaxff_kokkos.cpp +++ b/src/KOKKOS/pair_reaxff_kokkos.cpp @@ -3470,6 +3470,9 @@ void PairReaxFFKokkos::operator()(TagPairReaxUpdateBond, Kokkos::View::value>> a_Cdbopi2 = d_Cdbopi2; const int i = d_ilist[ii]; + const X_FLOAT xtmp = x(i,0); + const X_FLOAT ytmp = x(i,1); + const X_FLOAT ztmp = x(i,2); const tagint itag = tag(i); const int j_start = d_bo_first[i]; const int j_end = j_start + d_bo_num[i]; @@ -3478,6 +3481,21 @@ void PairReaxFFKokkos::operator()(TagPairReaxUpdateBond, int j = d_bo_list[jj]; j &= NEIGHMASK; const tagint jtag = tag(j); + + int flag = 0; + + if (itag > jtag) { + if ((itag+jtag) % 2 == 0) flag = 1; + } else if (itag < jtag) { + if ((itag+jtag) % 2 == 1) flag = 1; + } else { + if (x(j,2) < ztmp) flag = 1; + if (x(j,2) == ztmp && x(j,1) < ytmp) flag = 1; + if (x(j,2) == ztmp && x(j,1) == ytmp && x(j,0) < xtmp) flag = 1; + } + + if (!flag) continue; + const int j_index = jj - j_start; const F_FLOAT Cdbo_i = d_Cdbo(i,j_index); const F_FLOAT Cdbopi_i = d_Cdbopi(i,j_index); @@ -3492,18 +3510,9 @@ void PairReaxFFKokkos::operator()(TagPairReaxUpdateBond, if (k != i) continue; const int k_index = kk - k_start; - int flag = 0; - if (itag > jtag) { - if ((itag+jtag) % 2 == 0) flag = 1; - } else if (itag < jtag) { - if ((itag+jtag) % 2 == 1) flag = 1; - } - - if (flag) { - a_Cdbo(j,k_index) += Cdbo_i; - a_Cdbopi(j,k_index) += Cdbopi_i; - a_Cdbopi2(j,k_index) += Cdbopi2_i; - } + a_Cdbo(j,k_index) += Cdbo_i; + a_Cdbopi(j,k_index) += Cdbopi_i; + a_Cdbopi2(j,k_index) += Cdbopi2_i; } } } From 429cd204c4cfe625de4b275e58521a4b611ecc13 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Wed, 1 Jun 2022 16:26:25 -0600 Subject: [PATCH 281/585] bugfix in dipole neigh list memory usage --- src/AMOEBA/amoeba_induce.cpp | 3 ++ src/AMOEBA/pair_amoeba.h | 1 - src/info.cpp | 54 ++++++++++++++++++------------------ 3 files changed, 30 insertions(+), 28 deletions(-) diff --git a/src/AMOEBA/amoeba_induce.cpp b/src/AMOEBA/amoeba_induce.cpp index c075858a0f..884ba71edf 100644 --- a/src/AMOEBA/amoeba_induce.cpp +++ b/src/AMOEBA/amoeba_induce.cpp @@ -1194,6 +1194,9 @@ void PairAmoeba::udirect2b(double **field, double **fieldp) // compute the real space portion of the Ewald summation + ipage_dipole->reset(); + dpage_dipdip->reset(); + for (ii = 0; ii < inum; ii++) { i = ilist[ii]; itype = amtype[i]; diff --git a/src/AMOEBA/pair_amoeba.h b/src/AMOEBA/pair_amoeba.h index d8c3555c50..5adf0b84e6 100644 --- a/src/AMOEBA/pair_amoeba.h +++ b/src/AMOEBA/pair_amoeba.h @@ -63,7 +63,6 @@ class PairAmoeba : public Pair { protected: int nmax; // allocation for owned+ghost - int nlocalmax; // allocation for just owned int cfstyle,crstyle; // style of forward/reverse comm operations int nualt; double electric; diff --git a/src/info.cpp b/src/info.cpp index 2261b1d12d..fd8c233868 100644 --- a/src/info.cpp +++ b/src/info.cpp @@ -1296,45 +1296,45 @@ std::string Info::get_accelerator_info(const std::string &package) void Info::get_memory_info(double *meminfo) { - double bytes = 0; - bytes += atom->memory_usage(); - bytes += neighbor->memory_usage(); - bytes += comm->memory_usage(); - bytes += update->memory_usage(); - bytes += force->memory_usage(); - bytes += modify->memory_usage(); - for (int i = 0; i < output->ndump; i++) - bytes += output->dump[i]->memory_usage(); - meminfo[0] = bytes/1024.0/1024.0; - meminfo[1] = 0; - meminfo[2] = 0; + double bytes = 0; + bytes += atom->memory_usage(); + bytes += neighbor->memory_usage(); + bytes += comm->memory_usage(); + bytes += update->memory_usage(); + bytes += force->memory_usage(); + bytes += modify->memory_usage(); + for (int i = 0; i < output->ndump; i++) + bytes += output->dump[i]->memory_usage(); + meminfo[0] = bytes/1024.0/1024.0; + meminfo[1] = 0; + meminfo[2] = 0; #if defined(_WIN32) - HANDLE phandle = GetCurrentProcess(); - PROCESS_MEMORY_COUNTERS_EX pmc; - GetProcessMemoryInfo(phandle,(PROCESS_MEMORY_COUNTERS *)&pmc,sizeof(pmc)); - meminfo[1] = (double)pmc.PrivateUsage/1048576.0; - meminfo[2] = (double)pmc.PeakWorkingSetSize/1048576.0; + HANDLE phandle = GetCurrentProcess(); + PROCESS_MEMORY_COUNTERS_EX pmc; + GetProcessMemoryInfo(phandle,(PROCESS_MEMORY_COUNTERS *)&pmc,sizeof(pmc)); + meminfo[1] = (double)pmc.PrivateUsage/1048576.0; + meminfo[2] = (double)pmc.PeakWorkingSetSize/1048576.0; #else #if defined(__linux__) #if defined(__GLIBC__) && __GLIBC_PREREQ(2, 33) - struct mallinfo2 mi; - mi = mallinfo2(); + struct mallinfo2 mi; + mi = mallinfo2(); #else - struct mallinfo mi; - mi = mallinfo(); + struct mallinfo mi; + mi = mallinfo(); #endif - meminfo[1] = (double)mi.uordblks/1048576.0+(double)mi.hblkhd/1048576.0; + meminfo[1] = (double)mi.uordblks/1048576.0+(double)mi.hblkhd/1048576.0; #endif - struct rusage ru; - if (getrusage(RUSAGE_SELF, &ru) == 0) - meminfo[2] = (double)ru.ru_maxrss/1024.0; + struct rusage ru; + if (getrusage(RUSAGE_SELF, &ru) == 0) + meminfo[2] = (double)ru.ru_maxrss/1024.0; #endif } /* ---------------------------------------------------------------------- */ char **Info::get_variable_names(int &num) { - num = input->variable->nvar; - return input->variable->names; + num = input->variable->nvar; + return input->variable->names; } From 9f021ba4901a0d5f0286f286944d358adb7b7df3 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 1 Jun 2022 21:54:33 -0400 Subject: [PATCH 282/585] whitespace --- examples/PACKAGES/pace/in.pace.product | 42 ++++++++++++------------ examples/PACKAGES/pace/in.pace.recursive | 42 ++++++++++++------------ 2 files changed, 42 insertions(+), 42 deletions(-) diff --git a/examples/PACKAGES/pace/in.pace.product b/examples/PACKAGES/pace/in.pace.product index 11049ee922..1ba1fc679c 100644 --- a/examples/PACKAGES/pace/in.pace.product +++ b/examples/PACKAGES/pace/in.pace.product @@ -1,36 +1,36 @@ -# simple test of fcc Cu with ACE product +# simple test of fcc Cu with ACE product -units metal -atom_style atomic +units metal +atom_style atomic -neighbor 0.3 bin -neigh_modify every 2 delay 10 check yes +neighbor 0.3 bin +neigh_modify every 2 delay 10 check yes -variable a equal 3.597 -lattice fcc $a -region box block 0 4 0 4 0 4 -create_box 1 box -create_atoms 1 box +variable a equal 3.597 +lattice fcc $a +region box block 0 4 0 4 0 4 +create_box 1 box +create_atoms 1 box -mass 1 26.98 +mass 1 26.98 -pair_style pace product +pair_style pace product pair_coeff * * Cu-PBE-core-rep.ace Cu velocity all create 300 8728 loop geom timestep 0.0005 -fix 1 all nve +fix 1 all nve -compute eatom all pe/atom -compute energy all reduce sum c_eatom -variable delenergy equal c_energy-pe +compute eatom all pe/atom +compute energy all reduce sum c_eatom +variable delenergy equal c_energy-pe -compute satom all stress/atom NULL -compute str all reduce sum c_satom[1] c_satom[2] c_satom[3] -variable delpress equal -(c_str[1]+c_str[2]+c_str[3])/(3*vol)-press +compute satom all stress/atom NULL +compute str all reduce sum c_satom[1] c_satom[2] c_satom[3] +variable delpress equal -(c_str[1]+c_str[2]+c_str[3])/(3*vol)-press -thermo 10 +thermo 10 thermo_style custom step temp epair etotal press v_delenergy v_delpress -run 100 +run 100 diff --git a/examples/PACKAGES/pace/in.pace.recursive b/examples/PACKAGES/pace/in.pace.recursive index 1d6d9116f0..5d299fb033 100644 --- a/examples/PACKAGES/pace/in.pace.recursive +++ b/examples/PACKAGES/pace/in.pace.recursive @@ -1,36 +1,36 @@ -# simple test of fcc Cu with ACE recursive +# simple test of fcc Cu with ACE recursive -units metal -atom_style atomic +units metal +atom_style atomic -neighbor 0.3 bin -neigh_modify every 2 delay 10 check yes +neighbor 0.3 bin +neigh_modify every 2 delay 10 check yes -variable a equal 3.597 -lattice fcc $a -region box block 0 4 0 4 0 4 -create_box 1 box -create_atoms 1 box +variable a equal 3.597 +lattice fcc $a +region box block 0 4 0 4 0 4 +create_box 1 box +create_atoms 1 box -mass 1 26.98 +mass 1 26.98 -pair_style pace recursive +pair_style pace recursive pair_coeff * * Cu-PBE-core-rep.ace Cu velocity all create 300 8728 loop geom timestep 0.0005 -fix 1 all nve +fix 1 all nve -compute eatom all pe/atom -compute energy all reduce sum c_eatom -variable delenergy equal c_energy-pe +compute eatom all pe/atom +compute energy all reduce sum c_eatom +variable delenergy equal c_energy-pe -compute satom all stress/atom NULL -compute str all reduce sum c_satom[1] c_satom[2] c_satom[3] -variable delpress equal -(c_str[1]+c_str[2]+c_str[3])/(3*vol)-press +compute satom all stress/atom NULL +compute str all reduce sum c_satom[1] c_satom[2] c_satom[3] +variable delpress equal -(c_str[1]+c_str[2]+c_str[3])/(3*vol)-press -thermo 10 +thermo 10 thermo_style custom step temp epair etotal press v_delenergy v_delpress -run 100 +run 100 From 866391e8305dcea0d2b9f0603971957ec02d03e1 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 1 Jun 2022 21:56:13 -0400 Subject: [PATCH 283/585] modify so pair style pace will work as pair style hybrid substyle --- src/ML-PACE/pair_pace.cpp | 37 +++++++++++++++++++++++-------------- 1 file changed, 23 insertions(+), 14 deletions(-) diff --git a/src/ML-PACE/pair_pace.cpp b/src/ML-PACE/pair_pace.cpp index caaada65d7..594ab8d153 100644 --- a/src/ML-PACE/pair_pace.cpp +++ b/src/ML-PACE/pair_pace.cpp @@ -146,7 +146,10 @@ void PairPACE::compute(int eflag, int vflag) // the pointer to the list of neighbors of "i" firstneigh = list->firstneigh; +#if 0 + // when using a hybrid pair style inum != nlocal if (inum != nlocal) error->all(FLERR, "inum: {} nlocal: {} are different", inum, nlocal); +#endif // Aidan Thompson told RD (26 July 2019) that practically always holds: // inum = nlocal @@ -325,21 +328,27 @@ void PairPACE::coeff(int narg, char **arg) const int n = atom->ntypes; for (int i = 1; i <= n; i++) { - char *elemname = elemtypes[i - 1]; - int atomic_number = AtomicNumberByName_pace(elemname); - if (atomic_number == -1) error->all(FLERR, "'{}' is not a valid element\n", elemname); - - SPECIES_TYPE mu = aceimpl->basis_set->get_species_index_by_name(elemname); - if (mu != -1) { - if (comm->me == 0) - utils::logmesg(lmp, "Mapping LAMMPS atom type #{}({}) -> ACE species type #{}\n", i, - elemname, mu); - map[i] = mu; - // set up LAMMPS atom type to ACE species mapping for ace evaluator - aceimpl->ace->element_type_mapping(i) = mu; + SPECIES_TYPE mu = -1; + char *elemname = arg[2+i]; + if (strcmp(elemname, "NULL") == 0) { + aceimpl->ace->element_type_mapping(i) = 0; + map[i] = -1; + if (comm->me == 0) utils::logmesg(lmp, "Skipping LAMMPS atom type #{}(NULL)\n", i); } else { - error->all(FLERR, "Element {} is not supported by ACE-potential from file {}", elemname, - potential_file_name); + int atomic_number = AtomicNumberByName_pace(elemname); + if (atomic_number == -1) error->all(FLERR, "'{}' is not a valid element\n", elemname); + mu = aceimpl->basis_set->get_species_index_by_name(elemname); + if (mu != -1) { + if (comm->me == 0) + utils::logmesg(lmp, "Mapping LAMMPS atom type #{}({}) -> ACE species type #{}\n", i, + elemname, mu); + map[i] = mu; + // set up LAMMPS atom type to ACE species mapping for ace evaluator + aceimpl->ace->element_type_mapping(i) = mu; + } else { + error->all(FLERR, "Element {} is not supported by ACE-potential from file {}", elemname, + potential_file_name); + } } } From e36620059de4d34814f69d1ca179e66d6833a8fb Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 1 Jun 2022 22:08:35 -0400 Subject: [PATCH 284/585] simplify, apply clang-format --- src/ML-PACE/pair_pace.cpp | 9 ++++----- 1 file changed, 4 insertions(+), 5 deletions(-) diff --git a/src/ML-PACE/pair_pace.cpp b/src/ML-PACE/pair_pace.cpp index 594ab8d153..20cec3529e 100644 --- a/src/ML-PACE/pair_pace.cpp +++ b/src/ML-PACE/pair_pace.cpp @@ -272,7 +272,7 @@ void PairPACE::settings(int narg, char **arg) recursive = false; iarg += 1; } else if (strcmp(arg[iarg], "chunksize") == 0) { - chunksize = utils::inumeric(FLERR,arg[iarg+1],false,lmp); + chunksize = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else error->all(FLERR, "Illegal pair_style command"); @@ -328,8 +328,7 @@ void PairPACE::coeff(int narg, char **arg) const int n = atom->ntypes; for (int i = 1; i <= n; i++) { - SPECIES_TYPE mu = -1; - char *elemname = arg[2+i]; + char *elemname = arg[2 + i]; if (strcmp(elemname, "NULL") == 0) { aceimpl->ace->element_type_mapping(i) = 0; map[i] = -1; @@ -337,7 +336,7 @@ void PairPACE::coeff(int narg, char **arg) } else { int atomic_number = AtomicNumberByName_pace(elemname); if (atomic_number == -1) error->all(FLERR, "'{}' is not a valid element\n", elemname); - mu = aceimpl->basis_set->get_species_index_by_name(elemname); + SPECIES_TYPE mu = aceimpl->basis_set->get_species_index_by_name(elemname); if (mu != -1) { if (comm->me == 0) utils::logmesg(lmp, "Mapping LAMMPS atom type #{}({}) -> ACE species type #{}\n", i, @@ -354,7 +353,7 @@ void PairPACE::coeff(int narg, char **arg) // initialize scale factor for (int i = 1; i <= n; i++) { - for (int j = i; j <= n; j++) { scale[i][j] = 1.0; } + for (int j = i; j <= n; j++) scale[i][j] = 1.0; } aceimpl->ace->set_basis(*aceimpl->basis_set, 1); From c028dcbdf7d02004fac4b7254d625b54cc51c673 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 1 Jun 2022 22:14:04 -0400 Subject: [PATCH 285/585] small tweak --- unittest/force-styles/tests/mol-pair-lj_cut_tip4p_long.yaml | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/unittest/force-styles/tests/mol-pair-lj_cut_tip4p_long.yaml b/unittest/force-styles/tests/mol-pair-lj_cut_tip4p_long.yaml index 2579a3bf6c..28961cd04e 100644 --- a/unittest/force-styles/tests/mol-pair-lj_cut_tip4p_long.yaml +++ b/unittest/force-styles/tests/mol-pair-lj_cut_tip4p_long.yaml @@ -1,7 +1,7 @@ --- lammps_version: 17 Feb 2022 date_generated: Fri Mar 18 22:17:32 2022 -epsilon: 5e-12 +epsilon: 2e-11 skip_tests: prerequisites: ! | atom full From 8e415f0c00228cc304d9dfe5186e96795b87f444 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 1 Jun 2022 22:26:35 -0400 Subject: [PATCH 286/585] try to enforce QUIP submodule update strategy --- cmake/Modules/Packages/ML-QUIP.cmake | 1 + 1 file changed, 1 insertion(+) diff --git a/cmake/Modules/Packages/ML-QUIP.cmake b/cmake/Modules/Packages/ML-QUIP.cmake index 4db1eb1541..56221accab 100644 --- a/cmake/Modules/Packages/ML-QUIP.cmake +++ b/cmake/Modules/Packages/ML-QUIP.cmake @@ -43,6 +43,7 @@ if(DOWNLOAD_QUIP) file(WRITE ${CMAKE_BINARY_DIR}/quip.config "${temp}") message(STATUS "QUIP download via git requested - we will build our own") + set(CMAKE_EP_GIT_REMOTE_UPDATE_STRATEGY CHECKOUT) # QUIP has no releases (except for a tag marking the end of Python 2 support). We use the current "public" branch # The LAMMPS interface wrapper has a compatibility constant that is being checked at runtime. include(ExternalProject) From e214013a912b44aa80f8bfc550f8cde3bd073b0b Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 2 Jun 2022 07:53:41 -0400 Subject: [PATCH 287/585] tweak epsilon to avoid failure on FreeBSD --- unittest/force-styles/tests/fix-timestep-oneway.yaml | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/unittest/force-styles/tests/fix-timestep-oneway.yaml b/unittest/force-styles/tests/fix-timestep-oneway.yaml index c592517d8e..76a9d4c5a7 100644 --- a/unittest/force-styles/tests/fix-timestep-oneway.yaml +++ b/unittest/force-styles/tests/fix-timestep-oneway.yaml @@ -1,7 +1,7 @@ --- lammps_version: 17 Feb 2022 date_generated: Fri Mar 18 22:17:59 2022 -epsilon: 7.5e-14 +epsilon: 2e-13 skip_tests: prerequisites: ! | atom full From fdc8bcfbfcf677ce32b4f734ea82ce873546df95 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Thu, 2 Jun 2022 09:03:16 -0600 Subject: [PATCH 288/585] I removed the comment attributed to me, it is now outdated. --- src/ML-PACE/pair_pace.cpp | 8 -------- 1 file changed, 8 deletions(-) diff --git a/src/ML-PACE/pair_pace.cpp b/src/ML-PACE/pair_pace.cpp index 20cec3529e..1e77d2ee62 100644 --- a/src/ML-PACE/pair_pace.cpp +++ b/src/ML-PACE/pair_pace.cpp @@ -151,14 +151,6 @@ void PairPACE::compute(int eflag, int vflag) if (inum != nlocal) error->all(FLERR, "inum: {} nlocal: {} are different", inum, nlocal); #endif - // Aidan Thompson told RD (26 July 2019) that practically always holds: - // inum = nlocal - // i = ilist(ii) < inum - // j = jlist(jj) < nall - // neighborlist contains neighbor atoms plus skin atoms, - // skin atoms can be removed by setting skin to zero but here - // they are disregarded anyway - //determine the maximum number of neighbours int max_jnum = 0; int nei = 0; From 5a4688ed44a221abb7f496e2be2ff38270098258 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Thu, 2 Jun 2022 09:05:15 -0600 Subject: [PATCH 289/585] Update pair_pace.cpp --- src/ML-PACE/pair_pace.cpp | 5 ----- 1 file changed, 5 deletions(-) diff --git a/src/ML-PACE/pair_pace.cpp b/src/ML-PACE/pair_pace.cpp index 1e77d2ee62..56463a921e 100644 --- a/src/ML-PACE/pair_pace.cpp +++ b/src/ML-PACE/pair_pace.cpp @@ -146,11 +146,6 @@ void PairPACE::compute(int eflag, int vflag) // the pointer to the list of neighbors of "i" firstneigh = list->firstneigh; -#if 0 - // when using a hybrid pair style inum != nlocal - if (inum != nlocal) error->all(FLERR, "inum: {} nlocal: {} are different", inum, nlocal); -#endif - //determine the maximum number of neighbours int max_jnum = 0; int nei = 0; From 3a1423dc489f99f0af7d9734cec99059e1861e10 Mon Sep 17 00:00:00 2001 From: Giacomo Fiorin Date: Thu, 2 Jun 2022 11:24:04 -0400 Subject: [PATCH 290/585] Update Colvars to 2022-05-24 and copy of Lepton library One bugfix for the Colvars library in the ABF method, and update of the copy of the Lepton library as per the OpenMM repository. List of relevant PR. - 483 Update Lepton via patching procedure https://github.com/Colvars/colvars/pull/483 (@giacomofiorin) - 482 Fix integer overflow in log_gradient_finite_diff and gradient_finite_diff https://github.com/Colvars/colvars/pull/482 (@HanatoK) --- doc/src/PDF/colvars-refman-lammps.pdf | Bin 1490159 -> 1490159 bytes lib/colvars/Makefile.common | 22 +- lib/colvars/Makefile.lepton.deps | 22 +- lib/colvars/colvargrid.h | 20 +- lib/colvars/colvarproxy_tcl.cpp | 2 - lib/colvars/colvars_version.h | 2 +- .../include/lepton/CompiledExpression.h | 22 +- .../include/lepton/CompiledVectorExpression.h | 145 +++ .../lepton/include/lepton/CustomFunction.h | 2 +- .../lepton/include/lepton/ExpressionProgram.h | 2 +- .../include/lepton/ExpressionTreeNode.h | 8 +- lib/colvars/lepton/include/lepton/Operation.h | 2 +- .../lepton/include/lepton/ParsedExpression.h | 20 +- lib/colvars/lepton/src/CompiledExpression.cpp | 582 +++++++++-- .../lepton/src/CompiledVectorExpression.cpp | 933 ++++++++++++++++++ lib/colvars/lepton/src/ExpressionTreeNode.cpp | 48 +- lib/colvars/lepton/src/MSVC_erfc.h | 4 +- lib/colvars/lepton/src/Operation.cpp | 128 ++- lib/colvars/lepton/src/ParsedExpression.cpp | 211 ++-- lib/colvars/lepton/src/Parser.cpp | 2 +- 20 files changed, 1942 insertions(+), 235 deletions(-) create mode 100644 lib/colvars/lepton/include/lepton/CompiledVectorExpression.h create mode 100644 lib/colvars/lepton/src/CompiledVectorExpression.cpp diff --git a/doc/src/PDF/colvars-refman-lammps.pdf b/doc/src/PDF/colvars-refman-lammps.pdf index 71eaee867a76a108e0a8f58333d6a2ecfb513e8d..c87ccbad75a3c8a7e0ed46c69af5b0be057fb44f 100644 GIT binary patch delta 144 zcmaF=GwS`%sD>8C7N!>F7M2#)7Pc1l7LFFq7OocV7M>Q~7QPn#7J(MQ7NHj57LgXw zEn<7;Fd3Rm-#8C7N!>F7M2#)7Pc1l7LFFq7OocV7M>Q~7QPn#7J(MQ7NHj57LgXw zEn<7;FqxQ7-#G; S+1XCPhLDo&(aXf9hyef|Fe(=S diff --git a/lib/colvars/Makefile.common b/lib/colvars/Makefile.common index a920c24958..31a93652ae 100644 --- a/lib/colvars/Makefile.common +++ b/lib/colvars/Makefile.common @@ -62,10 +62,13 @@ COLVARS_SRCS = \ colvar_neuralnetworkcompute.cpp LEPTON_SRCS = \ - lepton/src/CompiledExpression.cpp lepton/src/ExpressionTreeNode.cpp \ - lepton/src/ParsedExpression.cpp lepton/src/ExpressionProgram.cpp \ - lepton/src/Operation.cpp lepton/src/Parser.cpp - + lepton/src/CompiledExpression.cpp \ + lepton/src/CompiledVectorExpression.cpp \ + lepton/src/ExpressionProgram.cpp \ + lepton/src/ExpressionTreeNode.cpp \ + lepton/src/Operation.cpp \ + lepton/src/ParsedExpression.cpp \ + lepton/src/Parser.cpp # Allow to selectively turn off Lepton ifeq ($(COLVARS_LEPTON),no) @@ -93,4 +96,13 @@ Makefile.deps: $(COLVARS_SRCS) done include Makefile.deps -include Makefile.lepton.deps # Hand-generated + +Makefile.lepton.deps: $(LEPTON_SRCS) + @echo > $@ + @for src in $^ ; do \ + obj=`basename $$src .cpp`.o ; \ + $(CXX) $(CXXFLAGS) -MM $(LEPTON_INCFLAGS) \ + -MT '$$(COLVARS_OBJ_DIR)'$$obj $$src >> $@ ; \ + done + +include Makefile.lepton.deps diff --git a/lib/colvars/Makefile.lepton.deps b/lib/colvars/Makefile.lepton.deps index 93c3912384..4546339de6 100644 --- a/lib/colvars/Makefile.lepton.deps +++ b/lib/colvars/Makefile.lepton.deps @@ -1,36 +1,46 @@ -lepton/src/CompiledExpression.o: lepton/src/CompiledExpression.cpp \ + +$(COLVARS_OBJ_DIR)CompiledExpression.o: lepton/src/CompiledExpression.cpp \ lepton/include/lepton/CompiledExpression.h \ lepton/include/lepton/ExpressionTreeNode.h \ lepton/include/lepton/windowsIncludes.h \ lepton/include/lepton/Operation.h lepton/include/lepton/CustomFunction.h \ lepton/include/lepton/Exception.h \ lepton/include/lepton/ParsedExpression.h -lepton/src/ExpressionProgram.o: lepton/src/ExpressionProgram.cpp \ +$(COLVARS_OBJ_DIR)CompiledVectorExpression.o: \ + lepton/src/CompiledVectorExpression.cpp \ + lepton/include/lepton/CompiledVectorExpression.h \ + lepton/include/lepton/ExpressionTreeNode.h \ + lepton/include/lepton/windowsIncludes.h \ + lepton/include/lepton/Operation.h lepton/include/lepton/CustomFunction.h \ + lepton/include/lepton/Exception.h \ + lepton/include/lepton/ParsedExpression.h +$(COLVARS_OBJ_DIR)ExpressionProgram.o: lepton/src/ExpressionProgram.cpp \ lepton/include/lepton/ExpressionProgram.h \ lepton/include/lepton/ExpressionTreeNode.h \ lepton/include/lepton/windowsIncludes.h \ lepton/include/lepton/Operation.h lepton/include/lepton/CustomFunction.h \ lepton/include/lepton/Exception.h \ lepton/include/lepton/ParsedExpression.h -lepton/src/ExpressionTreeNode.o: lepton/src/ExpressionTreeNode.cpp \ +$(COLVARS_OBJ_DIR)ExpressionTreeNode.o: lepton/src/ExpressionTreeNode.cpp \ lepton/include/lepton/ExpressionTreeNode.h \ lepton/include/lepton/windowsIncludes.h \ lepton/include/lepton/Exception.h lepton/include/lepton/Operation.h \ lepton/include/lepton/CustomFunction.h lepton/include/lepton/Exception.h -lepton/src/Operation.o: lepton/src/Operation.cpp \ +$(COLVARS_OBJ_DIR)Operation.o: lepton/src/Operation.cpp \ lepton/include/lepton/Operation.h \ lepton/include/lepton/windowsIncludes.h \ lepton/include/lepton/CustomFunction.h lepton/include/lepton/Exception.h \ lepton/include/lepton/ExpressionTreeNode.h lepton/src/MSVC_erfc.h -lepton/src/ParsedExpression.o: lepton/src/ParsedExpression.cpp \ +$(COLVARS_OBJ_DIR)ParsedExpression.o: lepton/src/ParsedExpression.cpp \ lepton/include/lepton/ParsedExpression.h \ lepton/include/lepton/ExpressionTreeNode.h \ lepton/include/lepton/windowsIncludes.h \ lepton/include/lepton/CompiledExpression.h \ + lepton/include/lepton/CompiledVectorExpression.h \ lepton/include/lepton/ExpressionProgram.h \ lepton/include/lepton/Operation.h lepton/include/lepton/CustomFunction.h \ lepton/include/lepton/Exception.h -lepton/src/Parser.o: lepton/src/Parser.cpp \ +$(COLVARS_OBJ_DIR)Parser.o: lepton/src/Parser.cpp \ lepton/include/lepton/Parser.h lepton/include/lepton/windowsIncludes.h \ lepton/include/lepton/CustomFunction.h lepton/include/lepton/Exception.h \ lepton/include/lepton/ExpressionTreeNode.h \ diff --git a/lib/colvars/colvargrid.h b/lib/colvars/colvargrid.h index e0b2ec7f03..f34c5eccab 100644 --- a/lib/colvars/colvargrid.h +++ b/lib/colvars/colvargrid.h @@ -1275,7 +1275,7 @@ public: inline cvm::real log_gradient_finite_diff(const std::vector &ix0, int n = 0) { - int A0, A1, A2; + cvm::real A0, A1, A2; std::vector ix = ix0; // TODO this can be rewritten more concisely with wrap_edge() @@ -1288,7 +1288,7 @@ public: if (A0 * A1 == 0) { return 0.; // can't handle empty bins } else { - return (cvm::logn((cvm::real)A1) - cvm::logn((cvm::real)A0)) + return (cvm::logn(A1) - cvm::logn(A0)) / (widths[n] * 2.); } } else if (ix[n] > 0 && ix[n] < nx[n]-1) { // not an edge @@ -1300,7 +1300,7 @@ public: if (A0 * A1 == 0) { return 0.; // can't handle empty bins } else { - return (cvm::logn((cvm::real)A1) - cvm::logn((cvm::real)A0)) + return (cvm::logn(A1) - cvm::logn(A0)) / (widths[n] * 2.); } } else { @@ -1313,8 +1313,8 @@ public: if (A0 * A1 * A2 == 0) { return 0.; // can't handle empty bins } else { - return (-1.5 * cvm::logn((cvm::real)A0) + 2. * cvm::logn((cvm::real)A1) - - 0.5 * cvm::logn((cvm::real)A2)) * increment / widths[n]; + return (-1.5 * cvm::logn(A0) + 2. * cvm::logn(A1) + - 0.5 * cvm::logn(A2)) * increment / widths[n]; } } } @@ -1324,7 +1324,7 @@ public: inline cvm::real gradient_finite_diff(const std::vector &ix0, int n = 0) { - int A0, A1, A2; + cvm::real A0, A1, A2; std::vector ix = ix0; // FIXME this can be rewritten more concisely with wrap_edge() @@ -1337,7 +1337,7 @@ public: if (A0 * A1 == 0) { return 0.; // can't handle empty bins } else { - return cvm::real(A1 - A0) / (widths[n] * 2.); + return (A1 - A0) / (widths[n] * 2.); } } else if (ix[n] > 0 && ix[n] < nx[n]-1) { // not an edge ix[n]--; @@ -1348,7 +1348,7 @@ public: if (A0 * A1 == 0) { return 0.; // can't handle empty bins } else { - return cvm::real(A1 - A0) / (widths[n] * 2.); + return (A1 - A0) / (widths[n] * 2.); } } else { // edge: use 2nd order derivative @@ -1357,8 +1357,8 @@ public: A0 = value(ix); ix[n] += increment; A1 = value(ix); ix[n] += increment; A2 = value(ix); - return (-1.5 * cvm::real(A0) + 2. * cvm::real(A1) - - 0.5 * cvm::real(A2)) * increment / widths[n]; + return (-1.5 * A0 + 2. * A1 + - 0.5 * A2) * increment / widths[n]; } } }; diff --git a/lib/colvars/colvarproxy_tcl.cpp b/lib/colvars/colvarproxy_tcl.cpp index 33bdc9dc38..700492f0e7 100644 --- a/lib/colvars/colvarproxy_tcl.cpp +++ b/lib/colvars/colvarproxy_tcl.cpp @@ -22,9 +22,7 @@ colvarproxy_tcl::colvarproxy_tcl() { -#ifdef COLVARS_TCL tcl_interp_ = NULL; -#endif } diff --git a/lib/colvars/colvars_version.h b/lib/colvars/colvars_version.h index 2a1d449ab5..d2a48f8af7 100644 --- a/lib/colvars/colvars_version.h +++ b/lib/colvars/colvars_version.h @@ -1,3 +1,3 @@ #ifndef COLVARS_VERSION -#define COLVARS_VERSION "2022-05-09" +#define COLVARS_VERSION "2022-05-24" #endif diff --git a/lib/colvars/lepton/include/lepton/CompiledExpression.h b/lib/colvars/lepton/include/lepton/CompiledExpression.h index c7e393e93b..84ec2eb410 100644 --- a/lib/colvars/lepton/include/lepton/CompiledExpression.h +++ b/lib/colvars/lepton/include/lepton/CompiledExpression.h @@ -9,7 +9,7 @@ * Biological Structures at Stanford, funded under the NIH Roadmap for * * Medical Research, grant U54 GM072970. See https://simtk.org. * * * - * Portions copyright (c) 2013-2019 Stanford University and the Authors. * + * Portions copyright (c) 2013-2022 Stanford University and the Authors. * * Authors: Peter Eastman * * Contributors: * * * @@ -40,7 +40,11 @@ #include #include #ifdef LEPTON_USE_JIT - #include "asmjit.h" +#if defined(__ARM__) || defined(__ARM64__) +#include "asmjit/a64.h" +#else +#include "asmjit/x86.h" +#endif #endif namespace Lepton { @@ -52,9 +56,9 @@ class ParsedExpression; * A CompiledExpression is a highly optimized representation of an expression for cases when you want to evaluate * it many times as quickly as possible. You should treat it as an opaque object; none of the internal representation * is visible. - * + * * A CompiledExpression is created by calling createCompiledExpression() on a ParsedExpression. - * + * * WARNING: CompiledExpression is NOT thread safe. You should never access a CompiledExpression from two threads at * the same time. */ @@ -101,9 +105,15 @@ private: std::map dummyVariables; double (*jitCode)(); #ifdef LEPTON_USE_JIT + void findPowerGroups(std::vector >& groups, std::vector >& groupPowers, std::vector& stepGroup); void generateJitCode(); - void generateSingleArgCall(asmjit::X86Compiler& c, asmjit::X86Xmm& dest, asmjit::X86Xmm& arg, double (*function)(double)); - void generateTwoArgCall(asmjit::X86Compiler& c, asmjit::X86Xmm& dest, asmjit::X86Xmm& arg1, asmjit::X86Xmm& arg2, double (*function)(double, double)); +#if defined(__ARM__) || defined(__ARM64__) + void generateSingleArgCall(asmjit::a64::Compiler& c, asmjit::arm::Vec& dest, asmjit::arm::Vec& arg, double (*function)(double)); + void generateTwoArgCall(asmjit::a64::Compiler& c, asmjit::arm::Vec& dest, asmjit::arm::Vec& arg1, asmjit::arm::Vec& arg2, double (*function)(double, double)); +#else + void generateSingleArgCall(asmjit::x86::Compiler& c, asmjit::x86::Xmm& dest, asmjit::x86::Xmm& arg, double (*function)(double)); + void generateTwoArgCall(asmjit::x86::Compiler& c, asmjit::x86::Xmm& dest, asmjit::x86::Xmm& arg1, asmjit::x86::Xmm& arg2, double (*function)(double, double)); +#endif std::vector constants; asmjit::JitRuntime runtime; #endif diff --git a/lib/colvars/lepton/include/lepton/CompiledVectorExpression.h b/lib/colvars/lepton/include/lepton/CompiledVectorExpression.h new file mode 100644 index 0000000000..a9dd936750 --- /dev/null +++ b/lib/colvars/lepton/include/lepton/CompiledVectorExpression.h @@ -0,0 +1,145 @@ +#ifndef LEPTON_VECTOR_EXPRESSION_H_ +#define LEPTON_VECTOR_EXPRESSION_H_ + +/* -------------------------------------------------------------------------- * + * Lepton * + * -------------------------------------------------------------------------- * + * This is part of the Lepton expression parser originating from * + * Simbios, the NIH National Center for Physics-Based Simulation of * + * Biological Structures at Stanford, funded under the NIH Roadmap for * + * Medical Research, grant U54 GM072970. See https://simtk.org. * + * * + * Portions copyright (c) 2013-2022 Stanford University and the Authors. * + * Authors: Peter Eastman * + * Contributors: * + * * + * Permission is hereby granted, free of charge, to any person obtaining a * + * copy of this software and associated documentation files (the "Software"), * + * to deal in the Software without restriction, including without limitation * + * the rights to use, copy, modify, merge, publish, distribute, sublicense, * + * and/or sell copies of the Software, and to permit persons to whom the * + * Software is furnished to do so, subject to the following conditions: * + * * + * The above copyright notice and this permission notice shall be included in * + * all copies or substantial portions of the Software. * + * * + * THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, EXPRESS OR * + * IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF MERCHANTABILITY, * + * FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. IN NO EVENT SHALL * + * THE AUTHORS, CONTRIBUTORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY CLAIM, * + * DAMAGES OR OTHER LIABILITY, WHETHER IN AN ACTION OF CONTRACT, TORT OR * + * OTHERWISE, ARISING FROM, OUT OF OR IN CONNECTION WITH THE SOFTWARE OR THE * + * USE OR OTHER DEALINGS IN THE SOFTWARE. * + * -------------------------------------------------------------------------- */ + +#include "ExpressionTreeNode.h" +#include "windowsIncludes.h" +#include +#include +#include +#include +#include +#include +#ifdef LEPTON_USE_JIT +#if defined(__ARM__) || defined(__ARM64__) +#include "asmjit/a64.h" +#else +#include "asmjit/x86.h" +#endif +#endif + +namespace Lepton { + +class Operation; +class ParsedExpression; + +/** + * A CompiledVectorExpression is a highly optimized representation of an expression for cases when you want to evaluate + * it many times as quickly as possible. It is similar to CompiledExpression, with the extra feature that it uses the CPU's + * vector unit (AVX on x86, NEON on ARM) to evaluate the expression for multiple sets of arguments at once. It also differs + * from CompiledExpression and ParsedExpression in using single precision rather than double precision to evaluate the expression. + * You should treat it as an opaque object; none of the internal representation is visible. + * + * A CompiledVectorExpression is created by calling createCompiledVectorExpression() on a ParsedExpression. When you create + * it, you must specify the width of the vectors on which to compute the expression. The allowed widths depend on the type of + * CPU it is running on. 4 is always allowed, and 8 is allowed on x86 processors with AVX. Call getAllowedWidths() to query + * the allowed values. + * + * WARNING: CompiledVectorExpression is NOT thread safe. You should never access a CompiledVectorExpression from two threads at + * the same time. + */ + +class LEPTON_EXPORT CompiledVectorExpression { +public: + CompiledVectorExpression(); + CompiledVectorExpression(const CompiledVectorExpression& expression); + ~CompiledVectorExpression(); + CompiledVectorExpression& operator=(const CompiledVectorExpression& expression); + /** + * Get the width of the vectors on which the expression is computed. + */ + int getWidth() const; + /** + * Get the names of all variables used by this expression. + */ + const std::set& getVariables() const; + /** + * Get a pointer to the memory location where the value of a particular variable is stored. This can be used + * to set the value of the variable before calling evaluate(). + * + * @param name the name of the variable to query + * @return a pointer to N floating point values, where N is the vector width + */ + float* getVariablePointer(const std::string& name); + /** + * You can optionally specify the memory locations from which the values of variables should be read. + * This is useful, for example, when several expressions all use the same variable. You can then set + * the value of that variable in one place, and it will be seen by all of them. The location should + * be a pointer to N floating point values, where N is the vector width. + */ + void setVariableLocations(std::map& variableLocations); + /** + * Evaluate the expression. The values of all variables should have been set before calling this. + * + * @return a pointer to N floating point values, where N is the vector width + */ + const float* evaluate() const; + /** + * Get the list of vector widths that are supported on the current processor. + */ + static const std::vector& getAllowedWidths(); +private: + friend class ParsedExpression; + CompiledVectorExpression(const ParsedExpression& expression, int width); + void compileExpression(const ExpressionTreeNode& node, std::vector >& temps, int& workspaceSize); + int findTempIndex(const ExpressionTreeNode& node, std::vector >& temps); + int width; + std::map variablePointers; + std::vector > variablesToCopy; + std::vector > arguments; + std::vector target; + std::vector operation; + std::map variableIndices; + std::set variableNames; + mutable std::vector workspace; + mutable std::vector argValues; + std::map dummyVariables; + void (*jitCode)(); +#ifdef LEPTON_USE_JIT + void findPowerGroups(std::vector >& groups, std::vector >& groupPowers, std::vector& stepGroup); + void generateJitCode(); +#if defined(__ARM__) || defined(__ARM64__) + void generateSingleArgCall(asmjit::a64::Compiler& c, asmjit::arm::Vec& dest, asmjit::arm::Vec& arg, float (*function)(float)); + void generateTwoArgCall(asmjit::a64::Compiler& c, asmjit::arm::Vec& dest, asmjit::arm::Vec& arg1, asmjit::arm::Vec& arg2, float (*function)(float, float)); +#else + void generateSingleArgCall(asmjit::x86::Compiler& c, asmjit::x86::Ymm& dest, asmjit::x86::Ymm& arg, float (*function)(float)); + void generateTwoArgCall(asmjit::x86::Compiler& c, asmjit::x86::Ymm& dest, asmjit::x86::Ymm& arg1, asmjit::x86::Ymm& arg2, float (*function)(float, float)); +#endif + std::vector constants; + asmjit::JitRuntime runtime; +#endif +}; + +} // namespace Lepton + +#endif /*LEPTON_VECTOR_EXPRESSION_H_*/ diff --git a/lib/colvars/lepton/include/lepton/CustomFunction.h b/lib/colvars/lepton/include/lepton/CustomFunction.h index fbb0ddd52a..7b6a2b6834 100644 --- a/lib/colvars/lepton/include/lepton/CustomFunction.h +++ b/lib/colvars/lepton/include/lepton/CustomFunction.h @@ -83,7 +83,7 @@ class LEPTON_EXPORT PlaceholderFunction : public CustomFunction { public: /** * Create a Placeholder function. - * + * * @param numArgs the number of arguments the function expects */ PlaceholderFunction(int numArgs) : numArgs(numArgs) { diff --git a/lib/colvars/lepton/include/lepton/ExpressionProgram.h b/lib/colvars/lepton/include/lepton/ExpressionProgram.h index a49a9094d0..e989906288 100644 --- a/lib/colvars/lepton/include/lepton/ExpressionProgram.h +++ b/lib/colvars/lepton/include/lepton/ExpressionProgram.h @@ -67,7 +67,7 @@ public: const Operation& getOperation(int index) const; /** * Change an Operation in this program. - * + * * The Operation must have been allocated on the heap with the "new" operator. * The ExpressionProgram assumes ownership of it and will delete it when it * is no longer needed. diff --git a/lib/colvars/lepton/include/lepton/ExpressionTreeNode.h b/lib/colvars/lepton/include/lepton/ExpressionTreeNode.h index bf3a9a0902..dde26103cb 100644 --- a/lib/colvars/lepton/include/lepton/ExpressionTreeNode.h +++ b/lib/colvars/lepton/include/lepton/ExpressionTreeNode.h @@ -9,7 +9,7 @@ * Biological Structures at Stanford, funded under the NIH Roadmap for * * Medical Research, grant U54 GM072970. See https://simtk.org. * * * - * Portions copyright (c) 2009 Stanford University and the Authors. * + * Portions copyright (c) 2009-2021 Stanford University and the Authors. * * Authors: Peter Eastman * * Contributors: * * * @@ -39,6 +39,7 @@ namespace Lepton { class Operation; +class ParsedExpression; /** * This class represents a node in the abstract syntax tree representation of an expression. @@ -82,11 +83,13 @@ public: */ ExpressionTreeNode(Operation* operation); ExpressionTreeNode(const ExpressionTreeNode& node); + ExpressionTreeNode(ExpressionTreeNode&& node); ExpressionTreeNode(); ~ExpressionTreeNode(); bool operator==(const ExpressionTreeNode& node) const; bool operator!=(const ExpressionTreeNode& node) const; ExpressionTreeNode& operator=(const ExpressionTreeNode& node); + ExpressionTreeNode& operator=(ExpressionTreeNode&& node); /** * Get the Operation performed by this node. */ @@ -96,8 +99,11 @@ public: */ const std::vector& getChildren() const; private: + friend class ParsedExpression; + void assignTags(std::vector& examples) const; Operation* operation; std::vector children; + mutable int tag; }; } // namespace Lepton diff --git a/lib/colvars/lepton/include/lepton/Operation.h b/lib/colvars/lepton/include/lepton/Operation.h index 1ddde0b8c0..4b8969cd59 100644 --- a/lib/colvars/lepton/include/lepton/Operation.h +++ b/lib/colvars/lepton/include/lepton/Operation.h @@ -1017,7 +1017,7 @@ public: double evaluate(double* args, const std::map& variables) const { if (isIntPower) { // Integer powers can be computed much more quickly by repeated multiplication. - + int exponent = intValue; double base = args[0]; if (exponent < 0) { diff --git a/lib/colvars/lepton/include/lepton/ParsedExpression.h b/lib/colvars/lepton/include/lepton/ParsedExpression.h index d88b3d5829..6c6526e525 100644 --- a/lib/colvars/lepton/include/lepton/ParsedExpression.h +++ b/lib/colvars/lepton/include/lepton/ParsedExpression.h @@ -9,7 +9,7 @@ * Biological Structures at Stanford, funded under the NIH Roadmap for * * Medical Research, grant U54 GM072970. See https://simtk.org. * * * - * Portions copyright (c) 2009=2013 Stanford University and the Authors. * + * Portions copyright (c) 2009-2022 Stanford University and the Authors. * * Authors: Peter Eastman * * Contributors: * * * @@ -41,6 +41,7 @@ namespace Lepton { class CompiledExpression; class ExpressionProgram; +class CompiledVectorExpression; /** * This class represents the result of parsing an expression. It provides methods for working with the @@ -102,6 +103,16 @@ public: * Create a CompiledExpression that represents the same calculation as this expression. */ CompiledExpression createCompiledExpression() const; + /** + * Create a CompiledVectorExpression that allows the expression to be evaluated efficiently + * using the CPU's vector unit. + * + * @param width the width of the vectors to evaluate it on. The allowed values + * depend on the CPU. 4 is always allowed, and 8 is allowed on + * x86 processors with AVX. Call CompiledVectorExpression::getAllowedWidths() + * to query the allowed widths on the current processor. + */ + CompiledVectorExpression createCompiledVectorExpression(int width) const; /** * Create a new ParsedExpression which is identical to this one, except that the names of some * variables have been changed. @@ -113,9 +124,10 @@ public: private: static double evaluate(const ExpressionTreeNode& node, const std::map& variables); static ExpressionTreeNode preevaluateVariables(const ExpressionTreeNode& node, const std::map& variables); - static ExpressionTreeNode precalculateConstantSubexpressions(const ExpressionTreeNode& node); - static ExpressionTreeNode substituteSimplerExpression(const ExpressionTreeNode& node); - static ExpressionTreeNode differentiate(const ExpressionTreeNode& node, const std::string& variable); + static ExpressionTreeNode precalculateConstantSubexpressions(const ExpressionTreeNode& node, std::map& nodeCache); + static ExpressionTreeNode substituteSimplerExpression(const ExpressionTreeNode& node, std::map& nodeCache); + static ExpressionTreeNode differentiate(const ExpressionTreeNode& node, const std::string& variable, std::map& nodeCache); + static bool isConstant(const ExpressionTreeNode& node); static double getConstantValue(const ExpressionTreeNode& node); static ExpressionTreeNode renameNodeVariables(const ExpressionTreeNode& node, const std::map& replacements); ExpressionTreeNode rootNode; diff --git a/lib/colvars/lepton/src/CompiledExpression.cpp b/lib/colvars/lepton/src/CompiledExpression.cpp index 1ad348b47d..8a0239b04f 100644 --- a/lib/colvars/lepton/src/CompiledExpression.cpp +++ b/lib/colvars/lepton/src/CompiledExpression.cpp @@ -6,7 +6,7 @@ * Biological Structures at Stanford, funded under the NIH Roadmap for * * Medical Research, grant U54 GM072970. See https://simtk.org. * * * - * Portions copyright (c) 2013-2019 Stanford University and the Authors. * + * Portions copyright (c) 2013-2022 Stanford University and the Authors. * * Authors: Peter Eastman * * Contributors: * * * @@ -84,17 +84,17 @@ CompiledExpression& CompiledExpression::operator=(const CompiledExpression& expr void CompiledExpression::compileExpression(const ExpressionTreeNode& node, vector >& temps) { if (findTempIndex(node, temps) != -1) return; // We have already processed a node identical to this one. - + // Process the child nodes. - + vector args; for (int i = 0; i < node.getChildren().size(); i++) { compileExpression(node.getChildren()[i], temps); args.push_back(findTempIndex(node.getChildren()[i], temps)); } - + // Process this node. - + if (node.getOperation().getId() == Operation::VARIABLE) { variableIndices[node.getOperation().getName()] = (int) workspace.size(); variableNames.insert(node.getOperation().getName()); @@ -108,7 +108,7 @@ void CompiledExpression::compileExpression(const ExpressionTreeNode& node, vecto arguments[stepIndex].push_back(0); // The value won't actually be used. We just need something there. else { // If the arguments are sequential, we can just pass a pointer to the first one. - + bool sequential = true; for (int i = 1; i < args.size(); i++) if (args[i] != args[i-1]+1) @@ -148,30 +148,28 @@ void CompiledExpression::setVariableLocations(map& variableLoca variablePointers = variableLocations; #ifdef LEPTON_USE_JIT // Rebuild the JIT code. - + if (workspace.size() > 0) generateJitCode(); -#else +#endif // Make a list of all variables we will need to copy before evaluating the expression. - + variablesToCopy.clear(); for (map::const_iterator iter = variableIndices.begin(); iter != variableIndices.end(); ++iter) { map::iterator pointer = variablePointers.find(iter->first); if (pointer != variablePointers.end()) variablesToCopy.push_back(make_pair(&workspace[iter->second], pointer->second)); } -#endif } double CompiledExpression::evaluate() const { -#ifdef LEPTON_USE_JIT - return jitCode(); -#else + if (jitCode) + return jitCode(); for (int i = 0; i < variablesToCopy.size(); i++) *variablesToCopy[i].first = *variablesToCopy[i].second; // Loop over the operations and evaluate each one. - + for (int step = 0; step < operation.size(); step++) { const vector& args = arguments[step]; if (args.size() == 1) @@ -183,7 +181,6 @@ double CompiledExpression::evaluate() const { } } return workspace[workspace.size()-1]; -#endif } #ifdef LEPTON_USE_JIT @@ -192,32 +189,78 @@ static double evaluateOperation(Operation* op, double* args) { return op->evaluate(args, dummyVariables); } +void CompiledExpression::findPowerGroups(vector >& groups, vector >& groupPowers, vector& stepGroup) { + // Identify every step that raises an argument to an integer power. + + vector stepPower(operation.size(), 0); + vector stepArg(operation.size(), -1); + for (int step = 0; step < operation.size(); step++) { + Operation& op = *operation[step]; + int power = 0; + if (op.getId() == Operation::SQUARE) + power = 2; + else if (op.getId() == Operation::CUBE) + power = 3; + else if (op.getId() == Operation::POWER_CONSTANT) { + double realPower = dynamic_cast(&op)->getValue(); + if (realPower == (int) realPower) + power = (int) realPower; + } + if (power != 0) { + stepPower[step] = power; + stepArg[step] = arguments[step][0]; + } + } + + // Find groups that operate on the same argument and whose powers have the same sign. + + stepGroup.resize(operation.size(), -1); + for (int i = 0; i < operation.size(); i++) { + if (stepGroup[i] != -1) + continue; + vector group, power; + for (int j = i; j < operation.size(); j++) { + if (stepArg[i] == stepArg[j] && stepPower[i]*stepPower[j] > 0) { + stepGroup[j] = groups.size(); + group.push_back(j); + power.push_back(stepPower[j]); + } + } + groups.push_back(group); + groupPowers.push_back(power); + } +} + +#if defined(__ARM__) || defined(__ARM64__) void CompiledExpression::generateJitCode() { CodeHolder code; - code.init(runtime.getCodeInfo()); - X86Compiler c(&code); - c.addFunc(FuncSignature0()); - vector workspaceVar(workspace.size()); + code.init(runtime.environment()); + a64::Compiler c(&code); + c.addFunc(FuncSignatureT()); + vector workspaceVar(workspace.size()); for (int i = 0; i < (int) workspaceVar.size(); i++) - workspaceVar[i] = c.newXmmSd(); - X86Gp argsPointer = c.newIntPtr(); - c.mov(argsPointer, imm_ptr(&argValues[0])); - + workspaceVar[i] = c.newVecD(); + arm::Gp argsPointer = c.newIntPtr(); + c.mov(argsPointer, imm(&argValues[0])); + vector > groups, groupPowers; + vector stepGroup; + findPowerGroups(groups, groupPowers, stepGroup); + // Load the arguments into variables. - + for (set::const_iterator iter = variableNames.begin(); iter != variableNames.end(); ++iter) { map::iterator index = variableIndices.find(*iter); - X86Gp variablePointer = c.newIntPtr(); - c.mov(variablePointer, imm_ptr(&getVariableReference(index->first))); - c.movsd(workspaceVar[index->second], x86::ptr(variablePointer, 0, 0)); + arm::Gp variablePointer = c.newIntPtr(); + c.mov(variablePointer, imm(&getVariableReference(index->first))); + c.ldr(workspaceVar[index->second], arm::ptr(variablePointer, 0)); } // Make a list of all constants that will be needed for evaluation. - + vector operationConstantIndex(operation.size(), -1); for (int step = 0; step < (int) operation.size(); step++) { // Find the constant value (if any) used by this operation. - + Operation& op = *operation[step]; double value; if (op.getId() == Operation::CONSTANT) @@ -232,11 +275,17 @@ void CompiledExpression::generateJitCode() { value = 1.0; else if (op.getId() == Operation::DELTA) value = 1.0; + else if (op.getId() == Operation::POWER_CONSTANT) { + if (stepGroup[step] == -1) + value = dynamic_cast(op).getValue(); + else + value = 1.0; + } else continue; - + // See if we already have a variable for this constant. - + for (int i = 0; i < (int) constants.size(); i++) if (value == constants[i]) { operationConstantIndex[step] = i; @@ -247,62 +296,101 @@ void CompiledExpression::generateJitCode() { constants.push_back(value); } } - + // Load constants into variables. - - vector constantVar(constants.size()); + + vector constantVar(constants.size()); if (constants.size() > 0) { - X86Gp constantsPointer = c.newIntPtr(); - c.mov(constantsPointer, imm_ptr(&constants[0])); + arm::Gp constantsPointer = c.newIntPtr(); + c.mov(constantsPointer, imm(&constants[0])); for (int i = 0; i < (int) constants.size(); i++) { - constantVar[i] = c.newXmmSd(); - c.movsd(constantVar[i], x86::ptr(constantsPointer, 8*i, 0)); + constantVar[i] = c.newVecD(); + c.ldr(constantVar[i], arm::ptr(constantsPointer, 8*i)); } } // Evaluate the operations. + vector hasComputedPower(operation.size(), false); for (int step = 0; step < (int) operation.size(); step++) { + if (hasComputedPower[step]) + continue; + + // When one or more steps involve raising the same argument to multiple integer + // powers, we can compute them all together for efficiency. + + if (stepGroup[step] != -1) { + vector& group = groups[stepGroup[step]]; + vector& powers = groupPowers[stepGroup[step]]; + arm::Vec multiplier = c.newVecD(); + if (powers[0] > 0) + c.fmov(multiplier, workspaceVar[arguments[step][0]]); + else { + c.fdiv(multiplier, constantVar[operationConstantIndex[step]], workspaceVar[arguments[step][0]]); + for (int i = 0; i < powers.size(); i++) + powers[i] = -powers[i]; + } + vector hasAssigned(group.size(), false); + bool done = false; + while (!done) { + done = true; + for (int i = 0; i < group.size(); i++) { + if (powers[i]%2 == 1) { + if (!hasAssigned[i]) + c.fmov(workspaceVar[target[group[i]]], multiplier); + else + c.fmul(workspaceVar[target[group[i]]], workspaceVar[target[group[i]]], multiplier); + hasAssigned[i] = true; + } + powers[i] >>= 1; + if (powers[i] != 0) + done = false; + } + if (!done) + c.fmul(multiplier, multiplier, multiplier); + } + for (int step : group) + hasComputedPower[step] = true; + continue; + } + + // Evaluate the step. + Operation& op = *operation[step]; vector args = arguments[step]; if (args.size() == 1) { // One or more sequential arguments. Fill out the list. - + for (int i = 1; i < op.getNumArguments(); i++) args.push_back(args[0]+i); } - + // Generate instructions to execute this operation. - + switch (op.getId()) { case Operation::CONSTANT: - c.movsd(workspaceVar[target[step]], constantVar[operationConstantIndex[step]]); + c.fmov(workspaceVar[target[step]], constantVar[operationConstantIndex[step]]); break; case Operation::ADD: - c.movsd(workspaceVar[target[step]], workspaceVar[args[0]]); - c.addsd(workspaceVar[target[step]], workspaceVar[args[1]]); + c.fadd(workspaceVar[target[step]], workspaceVar[args[0]], workspaceVar[args[1]]); break; case Operation::SUBTRACT: - c.movsd(workspaceVar[target[step]], workspaceVar[args[0]]); - c.subsd(workspaceVar[target[step]], workspaceVar[args[1]]); + c.fsub(workspaceVar[target[step]], workspaceVar[args[0]], workspaceVar[args[1]]); break; case Operation::MULTIPLY: - c.movsd(workspaceVar[target[step]], workspaceVar[args[0]]); - c.mulsd(workspaceVar[target[step]], workspaceVar[args[1]]); + c.fmul(workspaceVar[target[step]], workspaceVar[args[0]], workspaceVar[args[1]]); break; case Operation::DIVIDE: - c.movsd(workspaceVar[target[step]], workspaceVar[args[0]]); - c.divsd(workspaceVar[target[step]], workspaceVar[args[1]]); + c.fdiv(workspaceVar[target[step]], workspaceVar[args[0]], workspaceVar[args[1]]); break; case Operation::POWER: generateTwoArgCall(c, workspaceVar[target[step]], workspaceVar[args[0]], workspaceVar[args[1]], pow); break; case Operation::NEGATE: - c.xorps(workspaceVar[target[step]], workspaceVar[target[step]]); - c.subsd(workspaceVar[target[step]], workspaceVar[args[0]]); + c.fneg(workspaceVar[target[step]], workspaceVar[args[0]]); break; case Operation::SQRT: - c.sqrtsd(workspaceVar[target[step]], workspaceVar[args[0]]); + c.fsqrt(workspaceVar[target[step]], workspaceVar[args[0]]); break; case Operation::EXP: generateSingleArgCall(c, workspaceVar[target[step]], workspaceVar[args[0]], exp); @@ -341,56 +429,63 @@ void CompiledExpression::generateJitCode() { generateSingleArgCall(c, workspaceVar[target[step]], workspaceVar[args[0]], tanh); break; case Operation::STEP: - c.xorps(workspaceVar[target[step]], workspaceVar[target[step]]); - c.cmpsd(workspaceVar[target[step]], workspaceVar[args[0]], imm(18)); // Comparison mode is _CMP_LE_OQ = 18 - c.andps(workspaceVar[target[step]], constantVar[operationConstantIndex[step]]); + c.cmge(workspaceVar[target[step]], workspaceVar[args[0]], imm(0)); + c.and_(workspaceVar[target[step]], workspaceVar[target[step]], constantVar[operationConstantIndex[step]]); break; case Operation::DELTA: - c.xorps(workspaceVar[target[step]], workspaceVar[target[step]]); - c.cmpsd(workspaceVar[target[step]], workspaceVar[args[0]], imm(16)); // Comparison mode is _CMP_EQ_OS = 16 - c.andps(workspaceVar[target[step]], constantVar[operationConstantIndex[step]]); + c.cmeq(workspaceVar[target[step]], workspaceVar[args[0]], imm(0)); + c.and_(workspaceVar[target[step]], workspaceVar[target[step]], constantVar[operationConstantIndex[step]]); break; case Operation::SQUARE: - c.movsd(workspaceVar[target[step]], workspaceVar[args[0]]); - c.mulsd(workspaceVar[target[step]], workspaceVar[args[0]]); + c.fmul(workspaceVar[target[step]], workspaceVar[args[0]], workspaceVar[args[0]]); break; case Operation::CUBE: - c.movsd(workspaceVar[target[step]], workspaceVar[args[0]]); - c.mulsd(workspaceVar[target[step]], workspaceVar[args[0]]); - c.mulsd(workspaceVar[target[step]], workspaceVar[args[0]]); + c.fmul(workspaceVar[target[step]], workspaceVar[args[0]], workspaceVar[args[0]]); + c.fmul(workspaceVar[target[step]], workspaceVar[target[step]], workspaceVar[args[0]]); break; case Operation::RECIPROCAL: - c.movsd(workspaceVar[target[step]], constantVar[operationConstantIndex[step]]); - c.divsd(workspaceVar[target[step]], workspaceVar[args[0]]); + c.fdiv(workspaceVar[target[step]], constantVar[operationConstantIndex[step]], workspaceVar[args[0]]); break; case Operation::ADD_CONSTANT: - c.movsd(workspaceVar[target[step]], workspaceVar[args[0]]); - c.addsd(workspaceVar[target[step]], constantVar[operationConstantIndex[step]]); + c.fadd(workspaceVar[target[step]], workspaceVar[args[0]], constantVar[operationConstantIndex[step]]); break; case Operation::MULTIPLY_CONSTANT: - c.movsd(workspaceVar[target[step]], workspaceVar[args[0]]); - c.mulsd(workspaceVar[target[step]], constantVar[operationConstantIndex[step]]); + c.fmul(workspaceVar[target[step]], workspaceVar[args[0]], constantVar[operationConstantIndex[step]]); + break; + case Operation::POWER_CONSTANT: + generateTwoArgCall(c, workspaceVar[target[step]], workspaceVar[args[0]], constantVar[operationConstantIndex[step]], pow); + break; + case Operation::MIN: + c.fmin(workspaceVar[target[step]], workspaceVar[args[0]], workspaceVar[args[1]]); + break; + case Operation::MAX: + c.fmax(workspaceVar[target[step]], workspaceVar[args[0]], workspaceVar[args[1]]); break; case Operation::ABS: - generateSingleArgCall(c, workspaceVar[target[step]], workspaceVar[args[0]], fabs); + c.fabs(workspaceVar[target[step]], workspaceVar[args[0]]); break; case Operation::FLOOR: - generateSingleArgCall(c, workspaceVar[target[step]], workspaceVar[args[0]], floor); + c.frintm(workspaceVar[target[step]], workspaceVar[args[0]]); break; case Operation::CEIL: - generateSingleArgCall(c, workspaceVar[target[step]], workspaceVar[args[0]], ceil); + c.frintp(workspaceVar[target[step]], workspaceVar[args[0]]); + break; + case Operation::SELECT: + c.fcmeq(workspaceVar[target[step]], workspaceVar[args[0]], imm(0)); + c.bsl(workspaceVar[target[step]], workspaceVar[args[2]], workspaceVar[args[1]]); break; default: // Just invoke evaluateOperation(). - + for (int i = 0; i < (int) args.size(); i++) - c.movsd(x86::ptr(argsPointer, 8*i, 0), workspaceVar[args[i]]); - X86Gp fn = c.newIntPtr(); - c.mov(fn, imm_ptr((void*) evaluateOperation)); - CCFuncCall* call = c.call(fn, FuncSignature2()); - call->setArg(0, imm_ptr(&op)); - call->setArg(1, imm_ptr(&argValues[0])); - call->setRet(0, workspaceVar[target[step]]); + c.str(workspaceVar[args[i]], arm::ptr(argsPointer, 8*i)); + arm::Gp fn = c.newIntPtr(); + c.mov(fn, imm((void*) evaluateOperation)); + InvokeNode* invoke; + c.invoke(&invoke, fn, FuncSignatureT()); + invoke->setArg(0, imm(&op)); + invoke->setArg(1, imm(&argValues[0])); + invoke->setRet(0, workspaceVar[target[step]]); } } c.ret(workspaceVar[workspace.size()-1]); @@ -399,20 +494,319 @@ void CompiledExpression::generateJitCode() { runtime.add(&jitCode, &code); } -void CompiledExpression::generateSingleArgCall(X86Compiler& c, X86Xmm& dest, X86Xmm& arg, double (*function)(double)) { - X86Gp fn = c.newIntPtr(); - c.mov(fn, imm_ptr((void*) function)); - CCFuncCall* call = c.call(fn, FuncSignature1()); - call->setArg(0, arg); - call->setRet(0, dest); +void CompiledExpression::generateSingleArgCall(a64::Compiler& c, arm::Vec& dest, arm::Vec& arg, double (*function)(double)) { + arm::Gp fn = c.newIntPtr(); + c.mov(fn, imm((void*) function)); + InvokeNode* invoke; + c.invoke(&invoke, fn, FuncSignatureT()); + invoke->setArg(0, arg); + invoke->setRet(0, dest); } -void CompiledExpression::generateTwoArgCall(X86Compiler& c, X86Xmm& dest, X86Xmm& arg1, X86Xmm& arg2, double (*function)(double, double)) { - X86Gp fn = c.newIntPtr(); - c.mov(fn, imm_ptr((void*) function)); - CCFuncCall* call = c.call(fn, FuncSignature2()); - call->setArg(0, arg1); - call->setArg(1, arg2); - call->setRet(0, dest); +void CompiledExpression::generateTwoArgCall(a64::Compiler& c, arm::Vec& dest, arm::Vec& arg1, arm::Vec& arg2, double (*function)(double, double)) { + arm::Gp fn = c.newIntPtr(); + c.mov(fn, imm((void*) function)); + InvokeNode* invoke; + c.invoke(&invoke, fn, FuncSignatureT()); + invoke->setArg(0, arg1); + invoke->setArg(1, arg2); + invoke->setRet(0, dest); +} +#else +void CompiledExpression::generateJitCode() { + const CpuInfo& cpu = CpuInfo::host(); + if (!cpu.hasFeature(CpuFeatures::X86::kAVX)) + return; + CodeHolder code; + code.init(runtime.environment()); + x86::Compiler c(&code); + FuncNode* funcNode = c.addFunc(FuncSignatureT()); + funcNode->frame().setAvxEnabled(); + vector workspaceVar(workspace.size()); + for (int i = 0; i < (int) workspaceVar.size(); i++) + workspaceVar[i] = c.newXmmSd(); + x86::Gp argsPointer = c.newIntPtr(); + c.mov(argsPointer, imm(&argValues[0])); + vector > groups, groupPowers; + vector stepGroup; + findPowerGroups(groups, groupPowers, stepGroup); + + // Load the arguments into variables. + + x86::Gp variablePointer = c.newIntPtr(); + for (set::const_iterator iter = variableNames.begin(); iter != variableNames.end(); ++iter) { + map::iterator index = variableIndices.find(*iter); + c.mov(variablePointer, imm(&getVariableReference(index->first))); + c.vmovsd(workspaceVar[index->second], x86::ptr(variablePointer, 0, 0)); + } + + // Make a list of all constants that will be needed for evaluation. + + vector operationConstantIndex(operation.size(), -1); + for (int step = 0; step < (int) operation.size(); step++) { + // Find the constant value (if any) used by this operation. + + Operation& op = *operation[step]; + double value; + if (op.getId() == Operation::CONSTANT) + value = dynamic_cast(op).getValue(); + else if (op.getId() == Operation::ADD_CONSTANT) + value = dynamic_cast(op).getValue(); + else if (op.getId() == Operation::MULTIPLY_CONSTANT) + value = dynamic_cast(op).getValue(); + else if (op.getId() == Operation::RECIPROCAL) + value = 1.0; + else if (op.getId() == Operation::STEP) + value = 1.0; + else if (op.getId() == Operation::DELTA) + value = 1.0; + else if (op.getId() == Operation::ABS) { + long long mask = 0x7FFFFFFFFFFFFFFF; + value = *reinterpret_cast(&mask); + } + else if (op.getId() == Operation::POWER_CONSTANT) { + if (stepGroup[step] == -1) + value = dynamic_cast(op).getValue(); + else + value = 1.0; + } + else + continue; + + // See if we already have a variable for this constant. + + for (int i = 0; i < (int) constants.size(); i++) + if (value == constants[i]) { + operationConstantIndex[step] = i; + break; + } + if (operationConstantIndex[step] == -1) { + operationConstantIndex[step] = constants.size(); + constants.push_back(value); + } + } + + // Load constants into variables. + + vector constantVar(constants.size()); + if (constants.size() > 0) { + x86::Gp constantsPointer = c.newIntPtr(); + c.mov(constantsPointer, imm(&constants[0])); + for (int i = 0; i < (int) constants.size(); i++) { + constantVar[i] = c.newXmmSd(); + c.vmovsd(constantVar[i], x86::ptr(constantsPointer, 8*i, 0)); + } + } + + // Evaluate the operations. + + vector hasComputedPower(operation.size(), false); + for (int step = 0; step < (int) operation.size(); step++) { + if (hasComputedPower[step]) + continue; + + // When one or more steps involve raising the same argument to multiple integer + // powers, we can compute them all together for efficiency. + + if (stepGroup[step] != -1) { + vector& group = groups[stepGroup[step]]; + vector& powers = groupPowers[stepGroup[step]]; + x86::Xmm multiplier = c.newXmmSd(); + if (powers[0] > 0) + c.vmovsd(multiplier, workspaceVar[arguments[step][0]], workspaceVar[arguments[step][0]]); + else { + c.vdivsd(multiplier, constantVar[operationConstantIndex[step]], workspaceVar[arguments[step][0]]); + for (int i = 0; i < powers.size(); i++) + powers[i] = -powers[i]; + } + vector hasAssigned(group.size(), false); + bool done = false; + while (!done) { + done = true; + for (int i = 0; i < group.size(); i++) { + if (powers[i]%2 == 1) { + if (!hasAssigned[i]) + c.vmovsd(workspaceVar[target[group[i]]], multiplier, multiplier); + else + c.vmulsd(workspaceVar[target[group[i]]], workspaceVar[target[group[i]]], multiplier); + hasAssigned[i] = true; + } + powers[i] >>= 1; + if (powers[i] != 0) + done = false; + } + if (!done) + c.vmulsd(multiplier, multiplier, multiplier); + } + for (int step : group) + hasComputedPower[step] = true; + continue; + } + + // Evaluate the step. + + Operation& op = *operation[step]; + vector args = arguments[step]; + if (args.size() == 1) { + // One or more sequential arguments. Fill out the list. + + for (int i = 1; i < op.getNumArguments(); i++) + args.push_back(args[0]+i); + } + + // Generate instructions to execute this operation. + + switch (op.getId()) { + case Operation::CONSTANT: + c.vmovsd(workspaceVar[target[step]], constantVar[operationConstantIndex[step]], constantVar[operationConstantIndex[step]]); + break; + case Operation::ADD: + c.vaddsd(workspaceVar[target[step]], workspaceVar[args[0]], workspaceVar[args[1]]); + break; + case Operation::SUBTRACT: + c.vsubsd(workspaceVar[target[step]], workspaceVar[args[0]], workspaceVar[args[1]]); + break; + case Operation::MULTIPLY: + c.vmulsd(workspaceVar[target[step]], workspaceVar[args[0]], workspaceVar[args[1]]); + break; + case Operation::DIVIDE: + c.vdivsd(workspaceVar[target[step]], workspaceVar[args[0]], workspaceVar[args[1]]); + break; + case Operation::POWER: + generateTwoArgCall(c, workspaceVar[target[step]], workspaceVar[args[0]], workspaceVar[args[1]], pow); + break; + case Operation::NEGATE: + c.vxorps(workspaceVar[target[step]], workspaceVar[target[step]], workspaceVar[target[step]]); + c.vsubsd(workspaceVar[target[step]], workspaceVar[target[step]], workspaceVar[args[0]]); + break; + case Operation::SQRT: + c.vsqrtsd(workspaceVar[target[step]], workspaceVar[args[0]], workspaceVar[args[0]]); + break; + case Operation::EXP: + generateSingleArgCall(c, workspaceVar[target[step]], workspaceVar[args[0]], exp); + break; + case Operation::LOG: + generateSingleArgCall(c, workspaceVar[target[step]], workspaceVar[args[0]], log); + break; + case Operation::SIN: + generateSingleArgCall(c, workspaceVar[target[step]], workspaceVar[args[0]], sin); + break; + case Operation::COS: + generateSingleArgCall(c, workspaceVar[target[step]], workspaceVar[args[0]], cos); + break; + case Operation::TAN: + generateSingleArgCall(c, workspaceVar[target[step]], workspaceVar[args[0]], tan); + break; + case Operation::ASIN: + generateSingleArgCall(c, workspaceVar[target[step]], workspaceVar[args[0]], asin); + break; + case Operation::ACOS: + generateSingleArgCall(c, workspaceVar[target[step]], workspaceVar[args[0]], acos); + break; + case Operation::ATAN: + generateSingleArgCall(c, workspaceVar[target[step]], workspaceVar[args[0]], atan); + break; + case Operation::ATAN2: + generateTwoArgCall(c, workspaceVar[target[step]], workspaceVar[args[0]], workspaceVar[args[1]], atan2); + break; + case Operation::SINH: + generateSingleArgCall(c, workspaceVar[target[step]], workspaceVar[args[0]], sinh); + break; + case Operation::COSH: + generateSingleArgCall(c, workspaceVar[target[step]], workspaceVar[args[0]], cosh); + break; + case Operation::TANH: + generateSingleArgCall(c, workspaceVar[target[step]], workspaceVar[args[0]], tanh); + break; + case Operation::STEP: + c.vxorps(workspaceVar[target[step]], workspaceVar[target[step]], workspaceVar[target[step]]); + c.vcmpsd(workspaceVar[target[step]], workspaceVar[target[step]], workspaceVar[args[0]], imm(18)); // Comparison mode is _CMP_LE_OQ = 18 + c.vandps(workspaceVar[target[step]], workspaceVar[target[step]], constantVar[operationConstantIndex[step]]); + break; + case Operation::DELTA: + c.vxorps(workspaceVar[target[step]], workspaceVar[target[step]], workspaceVar[target[step]]); + c.vcmpsd(workspaceVar[target[step]], workspaceVar[target[step]], workspaceVar[args[0]], imm(16)); // Comparison mode is _CMP_EQ_OS = 16 + c.vandps(workspaceVar[target[step]], workspaceVar[target[step]], constantVar[operationConstantIndex[step]]); + break; + case Operation::SQUARE: + c.vmulsd(workspaceVar[target[step]], workspaceVar[args[0]], workspaceVar[args[0]]); + break; + case Operation::CUBE: + c.vmulsd(workspaceVar[target[step]], workspaceVar[args[0]], workspaceVar[args[0]]); + c.vmulsd(workspaceVar[target[step]], workspaceVar[target[step]], workspaceVar[args[0]]); + break; + case Operation::RECIPROCAL: + c.vdivsd(workspaceVar[target[step]], constantVar[operationConstantIndex[step]], workspaceVar[args[0]]); + break; + case Operation::ADD_CONSTANT: + c.vaddsd(workspaceVar[target[step]], workspaceVar[args[0]], constantVar[operationConstantIndex[step]]); + break; + case Operation::MULTIPLY_CONSTANT: + c.vmulsd(workspaceVar[target[step]], workspaceVar[args[0]], constantVar[operationConstantIndex[step]]); + break; + case Operation::POWER_CONSTANT: + generateTwoArgCall(c, workspaceVar[target[step]], workspaceVar[args[0]], constantVar[operationConstantIndex[step]], pow); + break; + case Operation::MIN: + c.vminsd(workspaceVar[target[step]], workspaceVar[args[0]], workspaceVar[args[1]]); + break; + case Operation::MAX: + c.vmaxsd(workspaceVar[target[step]], workspaceVar[args[0]], workspaceVar[args[1]]); + break; + case Operation::ABS: + c.vandpd(workspaceVar[target[step]], workspaceVar[args[0]], constantVar[operationConstantIndex[step]]); + break; + case Operation::FLOOR: + c.vroundsd(workspaceVar[target[step]], workspaceVar[args[0]], workspaceVar[args[0]], imm(1)); + break; + case Operation::CEIL: + c.vroundsd(workspaceVar[target[step]], workspaceVar[args[0]], workspaceVar[args[0]], imm(2)); + break; + case Operation::SELECT: + { + x86::Xmm mask = c.newXmmSd(); + c.vxorps(mask, mask, mask); + c.vcmpsd(mask, mask, workspaceVar[args[0]], imm(0)); // Comparison mode is _CMP_EQ_OQ = 0 + c.vblendvps(workspaceVar[target[step]], workspaceVar[args[1]], workspaceVar[args[2]], mask); + break; + } + default: + // Just invoke evaluateOperation(). + + for (int i = 0; i < (int) args.size(); i++) + c.vmovsd(x86::ptr(argsPointer, 8*i, 0), workspaceVar[args[i]]); + x86::Gp fn = c.newIntPtr(); + c.mov(fn, imm((void*) evaluateOperation)); + InvokeNode* invoke; + c.invoke(&invoke, fn, FuncSignatureT()); + invoke->setArg(0, imm(&op)); + invoke->setArg(1, imm(&argValues[0])); + invoke->setRet(0, workspaceVar[target[step]]); + } + } + c.ret(workspaceVar[workspace.size()-1]); + c.endFunc(); + c.finalize(); + runtime.add(&jitCode, &code); +} + +void CompiledExpression::generateSingleArgCall(x86::Compiler& c, x86::Xmm& dest, x86::Xmm& arg, double (*function)(double)) { + x86::Gp fn = c.newIntPtr(); + c.mov(fn, imm((void*) function)); + InvokeNode* invoke; + c.invoke(&invoke, fn, FuncSignatureT()); + invoke->setArg(0, arg); + invoke->setRet(0, dest); +} + +void CompiledExpression::generateTwoArgCall(x86::Compiler& c, x86::Xmm& dest, x86::Xmm& arg1, x86::Xmm& arg2, double (*function)(double, double)) { + x86::Gp fn = c.newIntPtr(); + c.mov(fn, imm((void*) function)); + InvokeNode* invoke; + c.invoke(&invoke, fn, FuncSignatureT()); + invoke->setArg(0, arg1); + invoke->setArg(1, arg2); + invoke->setRet(0, dest); } #endif +#endif diff --git a/lib/colvars/lepton/src/CompiledVectorExpression.cpp b/lib/colvars/lepton/src/CompiledVectorExpression.cpp new file mode 100644 index 0000000000..7c01a986bb --- /dev/null +++ b/lib/colvars/lepton/src/CompiledVectorExpression.cpp @@ -0,0 +1,933 @@ +/* -------------------------------------------------------------------------- * + * Lepton * + * -------------------------------------------------------------------------- * + * This is part of the Lepton expression parser originating from * + * Simbios, the NIH National Center for Physics-Based Simulation of * + * Biological Structures at Stanford, funded under the NIH Roadmap for * + * Medical Research, grant U54 GM072970. See https://simtk.org. * + * * + * Portions copyright (c) 2013-2022 Stanford University and the Authors. * + * Authors: Peter Eastman * + * Contributors: * + * * + * Permission is hereby granted, free of charge, to any person obtaining a * + * copy of this software and associated documentation files (the "Software"), * + * to deal in the Software without restriction, including without limitation * + * the rights to use, copy, modify, merge, publish, distribute, sublicense, * + * and/or sell copies of the Software, and to permit persons to whom the * + * Software is furnished to do so, subject to the following conditions: * + * * + * The above copyright notice and this permission notice shall be included in * + * all copies or substantial portions of the Software. * + * * + * THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, EXPRESS OR * + * IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF MERCHANTABILITY, * + * FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. IN NO EVENT SHALL * + * THE AUTHORS, CONTRIBUTORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY CLAIM, * + * DAMAGES OR OTHER LIABILITY, WHETHER IN AN ACTION OF CONTRACT, TORT OR * + * OTHERWISE, ARISING FROM, OUT OF OR IN CONNECTION WITH THE SOFTWARE OR THE * + * USE OR OTHER DEALINGS IN THE SOFTWARE. * + * -------------------------------------------------------------------------- */ + +#include "lepton/CompiledVectorExpression.h" +#include "lepton/Operation.h" +#include "lepton/ParsedExpression.h" +#include +#include + +using namespace Lepton; +using namespace std; +#ifdef LEPTON_USE_JIT +using namespace asmjit; +#endif + +CompiledVectorExpression::CompiledVectorExpression() : jitCode(NULL) { +} + +CompiledVectorExpression::CompiledVectorExpression(const ParsedExpression& expression, int width) : jitCode(NULL), width(width) { + const vector allowedWidths = getAllowedWidths(); + if (find(allowedWidths.begin(), allowedWidths.end(), width) == allowedWidths.end()) + throw Exception("Unsupported width for vector expression: "+to_string(width)); + ParsedExpression expr = expression.optimize(); // Just in case it wasn't already optimized. + vector > temps; + int workspaceSize = 0; + compileExpression(expr.getRootNode(), temps, workspaceSize); + workspace.resize(workspaceSize*width); + int maxArguments = 1; + for (int i = 0; i < (int) operation.size(); i++) + if (operation[i]->getNumArguments() > maxArguments) + maxArguments = operation[i]->getNumArguments(); + argValues.resize(maxArguments); +#ifdef LEPTON_USE_JIT + generateJitCode(); +#endif +} + +CompiledVectorExpression::~CompiledVectorExpression() { + for (int i = 0; i < (int) operation.size(); i++) + if (operation[i] != NULL) + delete operation[i]; +} + +CompiledVectorExpression::CompiledVectorExpression(const CompiledVectorExpression& expression) : jitCode(NULL) { + *this = expression; +} + +CompiledVectorExpression& CompiledVectorExpression::operator=(const CompiledVectorExpression& expression) { + arguments = expression.arguments; + width = expression.width; + target = expression.target; + variableIndices = expression.variableIndices; + variableNames = expression.variableNames; + workspace.resize(expression.workspace.size()); + argValues.resize(expression.argValues.size()); + operation.resize(expression.operation.size()); + for (int i = 0; i < (int) operation.size(); i++) + operation[i] = expression.operation[i]->clone(); + setVariableLocations(variablePointers); + return *this; +} + +const vector& CompiledVectorExpression::getAllowedWidths() { + static vector widths; + if (widths.size() == 0) { + widths.push_back(4); +#ifdef LEPTON_USE_JIT + const CpuInfo& cpu = CpuInfo::host(); + if (cpu.hasFeature(CpuFeatures::X86::kAVX)) + widths.push_back(8); +#endif + } + return widths; +} + +void CompiledVectorExpression::compileExpression(const ExpressionTreeNode& node, vector >& temps, int& workspaceSize) { + if (findTempIndex(node, temps) != -1) + return; // We have already processed a node identical to this one. + + // Process the child nodes. + + vector args; + for (int i = 0; i < node.getChildren().size(); i++) { + compileExpression(node.getChildren()[i], temps, workspaceSize); + args.push_back(findTempIndex(node.getChildren()[i], temps)); + } + + // Process this node. + + if (node.getOperation().getId() == Operation::VARIABLE) { + variableIndices[node.getOperation().getName()] = workspaceSize; + variableNames.insert(node.getOperation().getName()); + } + else { + int stepIndex = (int) arguments.size(); + arguments.push_back(vector()); + target.push_back(workspaceSize); + operation.push_back(node.getOperation().clone()); + if (args.size() == 0) + arguments[stepIndex].push_back(0); // The value won't actually be used. We just need something there. + else { + // If the arguments are sequential, we can just pass a pointer to the first one. + + bool sequential = true; + for (int i = 1; i < args.size(); i++) + if (args[i] != args[i - 1] + 1) + sequential = false; + if (sequential) + arguments[stepIndex].push_back(args[0]); + else + arguments[stepIndex] = args; + } + } + temps.push_back(make_pair(node, workspaceSize)); + workspaceSize++; +} + +int CompiledVectorExpression::findTempIndex(const ExpressionTreeNode& node, vector >& temps) { + for (int i = 0; i < (int) temps.size(); i++) + if (temps[i].first == node) + return i; + return -1; +} + +int CompiledVectorExpression::getWidth() const { + return width; +} + +const set& CompiledVectorExpression::getVariables() const { + return variableNames; +} + +float* CompiledVectorExpression::getVariablePointer(const string& name) { + map::iterator pointer = variablePointers.find(name); + if (pointer != variablePointers.end()) + return pointer->second; + map::iterator index = variableIndices.find(name); + if (index == variableIndices.end()) + throw Exception("getVariableReference: Unknown variable '" + name + "'"); + return &workspace[index->second*width]; +} + +void CompiledVectorExpression::setVariableLocations(map& variableLocations) { + variablePointers = variableLocations; +#ifdef LEPTON_USE_JIT + // Rebuild the JIT code. + + if (workspace.size() > 0) + generateJitCode(); +#endif + // Make a list of all variables we will need to copy before evaluating the expression. + + variablesToCopy.clear(); + for (map::const_iterator iter = variableIndices.begin(); iter != variableIndices.end(); ++iter) { + map::iterator pointer = variablePointers.find(iter->first); + if (pointer != variablePointers.end()) + variablesToCopy.push_back(make_pair(&workspace[iter->second*width], pointer->second)); + } +} + +const float* CompiledVectorExpression::evaluate() const { + if (jitCode) { + jitCode(); + return &workspace[workspace.size()-width]; + } + for (int i = 0; i < variablesToCopy.size(); i++) + for (int j = 0; j < width; j++) + variablesToCopy[i].first[j] = variablesToCopy[i].second[j]; + + // Loop over the operations and evaluate each one. + + for (int step = 0; step < operation.size(); step++) { + const vector& args = arguments[step]; + if (args.size() == 1) { + for (int j = 0; j < width; j++) { + for (int i = 0; i < operation[step]->getNumArguments(); i++) + argValues[i] = workspace[(args[0]+i)*width+j]; + workspace[target[step]*width+j] = operation[step]->evaluate(&argValues[0], dummyVariables); + } + } else { + for (int j = 0; j < width; j++) { + for (int i = 0; i < args.size(); i++) + argValues[i] = workspace[args[i]*width+j]; + workspace[target[step]*width+j] = operation[step]->evaluate(&argValues[0], dummyVariables); + } + } + } + return &workspace[workspace.size()-width]; +} + +#ifdef LEPTON_USE_JIT + +static double evaluateOperation(Operation* op, double* args) { + static map dummyVariables; + return op->evaluate(args, dummyVariables); +} + +void CompiledVectorExpression::findPowerGroups(vector >& groups, vector >& groupPowers, vector& stepGroup) { + // Identify every step that raises an argument to an integer power. + + vector stepPower(operation.size(), 0); + vector stepArg(operation.size(), -1); + for (int step = 0; step < operation.size(); step++) { + Operation& op = *operation[step]; + int power = 0; + if (op.getId() == Operation::SQUARE) + power = 2; + else if (op.getId() == Operation::CUBE) + power = 3; + else if (op.getId() == Operation::POWER_CONSTANT) { + double realPower = dynamic_cast (&op)->getValue(); + if (realPower == (int) realPower) + power = (int) realPower; + } + if (power != 0) { + stepPower[step] = power; + stepArg[step] = arguments[step][0]; + } + } + + // Find groups that operate on the same argument and whose powers have the same sign. + + stepGroup.resize(operation.size(), -1); + for (int i = 0; i < operation.size(); i++) { + if (stepGroup[i] != -1) + continue; + vector group, power; + for (int j = i; j < operation.size(); j++) { + if (stepArg[i] == stepArg[j] && stepPower[i] * stepPower[j] > 0) { + stepGroup[j] = groups.size(); + group.push_back(j); + power.push_back(stepPower[j]); + } + } + groups.push_back(group); + groupPowers.push_back(power); + } +} + +#if defined(__ARM__) || defined(__ARM64__) + +void CompiledVectorExpression::generateJitCode() { + CodeHolder code; + code.init(runtime.environment()); + a64::Compiler c(&code); + c.addFunc(FuncSignatureT()); + vector workspaceVar(workspace.size()/width); + for (int i = 0; i < (int) workspaceVar.size(); i++) + workspaceVar[i] = c.newVecQ(); + arm::Gp argsPointer = c.newIntPtr(); + c.mov(argsPointer, imm(&argValues[0])); + vector > groups, groupPowers; + vector stepGroup; + findPowerGroups(groups, groupPowers, stepGroup); + + // Load the arguments into variables. + + arm::Gp variablePointer = c.newIntPtr(); + for (set::const_iterator iter = variableNames.begin(); iter != variableNames.end(); ++iter) { + map::iterator index = variableIndices.find(*iter); + c.mov(variablePointer, imm(getVariablePointer(index->first))); + c.ldr(workspaceVar[index->second].s4(), arm::ptr(variablePointer, 0)); + } + + // Make a list of all constants that will be needed for evaluation. + + vector operationConstantIndex(operation.size(), -1); + for (int step = 0; step < (int) operation.size(); step++) { + // Find the constant value (if any) used by this operation. + + Operation& op = *operation[step]; + float value; + if (op.getId() == Operation::CONSTANT) + value = dynamic_cast (op).getValue(); + else if (op.getId() == Operation::ADD_CONSTANT) + value = dynamic_cast (op).getValue(); + else if (op.getId() == Operation::MULTIPLY_CONSTANT) + value = dynamic_cast (op).getValue(); + else if (op.getId() == Operation::RECIPROCAL) + value = 1.0; + else if (op.getId() == Operation::STEP) + value = 1.0; + else if (op.getId() == Operation::DELTA) + value = 1.0; + else if (op.getId() == Operation::POWER_CONSTANT) { + if (stepGroup[step] == -1) + value = dynamic_cast (op).getValue(); + else + value = 1.0; + } else + continue; + + // See if we already have a variable for this constant. + + for (int i = 0; i < (int) constants.size(); i++) + if (value == constants[i]) { + operationConstantIndex[step] = i; + break; + } + if (operationConstantIndex[step] == -1) { + operationConstantIndex[step] = constants.size(); + constants.push_back(value); + } + } + + // Load constants into variables. + + vector constantVar(constants.size()); + if (constants.size() > 0) { + arm::Gp constantsPointer = c.newIntPtr(); + for (int i = 0; i < (int) constants.size(); i++) { + c.mov(constantsPointer, imm(&constants[i])); + constantVar[i] = c.newVecQ(); + c.ld1r(constantVar[i].s4(), arm::ptr(constantsPointer)); + } + } + + // Evaluate the operations. + + vector hasComputedPower(operation.size(), false); + arm::Vec argReg = c.newVecS(); + arm::Vec doubleArgReg = c.newVecD(); + arm::Vec doubleResultReg = c.newVecD(); + for (int step = 0; step < (int) operation.size(); step++) { + if (hasComputedPower[step]) + continue; + + // When one or more steps involve raising the same argument to multiple integer + // powers, we can compute them all together for efficiency. + + if (stepGroup[step] != -1) { + vector& group = groups[stepGroup[step]]; + vector& powers = groupPowers[stepGroup[step]]; + arm::Vec multiplier = c.newVecQ(); + if (powers[0] > 0) + c.mov(multiplier.s4(), workspaceVar[arguments[step][0]].s4()); + else { + c.fdiv(multiplier.s4(), constantVar[operationConstantIndex[step]].s4(), workspaceVar[arguments[step][0]].s4()); + for (int i = 0; i < powers.size(); i++) + powers[i] = -powers[i]; + } + vector hasAssigned(group.size(), false); + bool done = false; + while (!done) { + done = true; + for (int i = 0; i < group.size(); i++) { + if (powers[i] % 2 == 1) { + if (!hasAssigned[i]) + c.mov(workspaceVar[target[group[i]]].s4(), multiplier.s4()); + else + c.fmul(workspaceVar[target[group[i]]].s4(), workspaceVar[target[group[i]]].s4(), multiplier.s4()); + hasAssigned[i] = true; + } + powers[i] >>= 1; + if (powers[i] != 0) + done = false; + } + if (!done) + c.fmul(multiplier.s4(), multiplier.s4(), multiplier.s4()); + } + for (int step : group) + hasComputedPower[step] = true; + continue; + } + + // Evaluate the step. + + Operation& op = *operation[step]; + vector args = arguments[step]; + if (args.size() == 1) { + // One or more sequential arguments. Fill out the list. + + for (int i = 1; i < op.getNumArguments(); i++) + args.push_back(args[0] + i); + } + + // Generate instructions to execute this operation. + + switch (op.getId()) { + case Operation::CONSTANT: + c.mov(workspaceVar[target[step]].s4(), constantVar[operationConstantIndex[step]].s4()); + break; + case Operation::ADD: + c.fadd(workspaceVar[target[step]].s4(), workspaceVar[args[0]].s4(), workspaceVar[args[1]].s4()); + break; + case Operation::SUBTRACT: + c.fsub(workspaceVar[target[step]].s4(), workspaceVar[args[0]].s4(), workspaceVar[args[1]].s4()); + break; + case Operation::MULTIPLY: + c.fmul(workspaceVar[target[step]].s4(), workspaceVar[args[0]].s4(), workspaceVar[args[1]].s4()); + break; + case Operation::DIVIDE: + c.fdiv(workspaceVar[target[step]].s4(), workspaceVar[args[0]].s4(), workspaceVar[args[1]].s4()); + break; + case Operation::POWER: + generateTwoArgCall(c, workspaceVar[target[step]], workspaceVar[args[0]], workspaceVar[args[1]], powf); + break; + case Operation::NEGATE: + c.fneg(workspaceVar[target[step]].s4(), workspaceVar[args[0]].s4()); + break; + case Operation::SQRT: + c.fsqrt(workspaceVar[target[step]].s4(), workspaceVar[args[0]].s4()); + break; + case Operation::EXP: + generateSingleArgCall(c, workspaceVar[target[step]], workspaceVar[args[0]], expf); + break; + case Operation::LOG: + generateSingleArgCall(c, workspaceVar[target[step]], workspaceVar[args[0]], logf); + break; + case Operation::SIN: + generateSingleArgCall(c, workspaceVar[target[step]], workspaceVar[args[0]], sinf); + break; + case Operation::COS: + generateSingleArgCall(c, workspaceVar[target[step]], workspaceVar[args[0]], cosf); + break; + case Operation::TAN: + generateSingleArgCall(c, workspaceVar[target[step]], workspaceVar[args[0]], tanf); + break; + case Operation::ASIN: + generateSingleArgCall(c, workspaceVar[target[step]], workspaceVar[args[0]], asinf); + break; + case Operation::ACOS: + generateSingleArgCall(c, workspaceVar[target[step]], workspaceVar[args[0]], acosf); + break; + case Operation::ATAN: + generateSingleArgCall(c, workspaceVar[target[step]], workspaceVar[args[0]], atanf); + break; + case Operation::ATAN2: + generateTwoArgCall(c, workspaceVar[target[step]], workspaceVar[args[0]], workspaceVar[args[1]], atan2f); + break; + case Operation::SINH: + generateSingleArgCall(c, workspaceVar[target[step]], workspaceVar[args[0]], sinhf); + break; + case Operation::COSH: + generateSingleArgCall(c, workspaceVar[target[step]], workspaceVar[args[0]], coshf); + break; + case Operation::TANH: + generateSingleArgCall(c, workspaceVar[target[step]], workspaceVar[args[0]], tanhf); + break; + case Operation::STEP: + c.cmge(workspaceVar[target[step]].s4(), workspaceVar[args[0]].s4(), imm(0)); + c.and_(workspaceVar[target[step]], workspaceVar[target[step]], constantVar[operationConstantIndex[step]]); + break; + case Operation::DELTA: + c.cmeq(workspaceVar[target[step]].s4(), workspaceVar[args[0]].s4(), imm(0)); + c.and_(workspaceVar[target[step]], workspaceVar[target[step]], constantVar[operationConstantIndex[step]]); + break; + case Operation::SQUARE: + c.fmul(workspaceVar[target[step]].s4(), workspaceVar[args[0]].s4(), workspaceVar[args[0]].s4()); + break; + case Operation::CUBE: + c.fmul(workspaceVar[target[step]].s4(), workspaceVar[args[0]].s4(), workspaceVar[args[0]].s4()); + c.fmul(workspaceVar[target[step]].s4(), workspaceVar[target[step]].s4(), workspaceVar[args[0]].s4()); + break; + case Operation::RECIPROCAL: + c.fdiv(workspaceVar[target[step]].s4(), constantVar[operationConstantIndex[step]].s4(), workspaceVar[args[0]].s4()); + break; + case Operation::ADD_CONSTANT: + c.fadd(workspaceVar[target[step]].s4(), workspaceVar[args[0]].s4(), constantVar[operationConstantIndex[step]].s4()); + break; + case Operation::MULTIPLY_CONSTANT: + c.fmul(workspaceVar[target[step]].s4(), workspaceVar[args[0]].s4(), constantVar[operationConstantIndex[step]].s4()); + break; + case Operation::POWER_CONSTANT: + generateTwoArgCall(c, workspaceVar[target[step]], workspaceVar[args[0]], constantVar[operationConstantIndex[step]], powf); + break; + case Operation::MIN: + c.fmin(workspaceVar[target[step]].s4(), workspaceVar[args[0]].s4(), workspaceVar[args[1]].s4()); + break; + case Operation::MAX: + c.fmax(workspaceVar[target[step]].s4(), workspaceVar[args[0]].s4(), workspaceVar[args[1]].s4()); + break; + case Operation::ABS: + c.fabs(workspaceVar[target[step]].s4(), workspaceVar[args[0]].s4()); + break; + case Operation::FLOOR: + c.frintm(workspaceVar[target[step]].s4(), workspaceVar[args[0]].s4()); + break; + case Operation::CEIL: + c.frintp(workspaceVar[target[step]].s4(), workspaceVar[args[0]].s4()); + break; + case Operation::SELECT: + c.fcmeq(workspaceVar[target[step]].s4(), workspaceVar[args[0]].s4(), imm(0)); + c.bsl(workspaceVar[target[step]], workspaceVar[args[2]], workspaceVar[args[1]]); + break; + default: + // Just invoke evaluateOperation(). + for (int element = 0; element < width; element++) { + for (int i = 0; i < (int) args.size(); i++) { + c.ins(argReg.s(0), workspaceVar[args[i]].s(element)); + c.fcvt(doubleArgReg, argReg); + c.str(doubleArgReg, arm::ptr(argsPointer, 8*i)); + } + arm::Gp fn = c.newIntPtr(); + c.mov(fn, imm((void*) evaluateOperation)); + InvokeNode* invoke; + c.invoke(&invoke, fn, FuncSignatureT()); + invoke->setArg(0, imm(&op)); + invoke->setArg(1, imm(&argValues[0])); + invoke->setRet(0, doubleResultReg); + c.fcvt(argReg, doubleResultReg); + c.ins(workspaceVar[target[step]].s(element), argReg.s(0)); + } + } + } + arm::Gp resultPointer = c.newIntPtr(); + c.mov(resultPointer, imm(&workspace[workspace.size()-width])); + c.str(workspaceVar.back().s4(), arm::ptr(resultPointer, 0)); + c.endFunc(); + c.finalize(); + runtime.add(&jitCode, &code); +} + +void CompiledVectorExpression::generateSingleArgCall(a64::Compiler& c, arm::Vec& dest, arm::Vec& arg, float (*function)(float)) { + arm::Gp fn = c.newIntPtr(); + c.mov(fn, imm((void*) function)); + arm::Vec a = c.newVecS(); + arm::Vec d = c.newVecS(); + for (int element = 0; element < width; element++) { + c.ins(a.s(0), arg.s(element)); + InvokeNode* invoke; + c.invoke(&invoke, fn, FuncSignatureT()); + invoke->setArg(0, a); + invoke->setRet(0, d); + c.ins(dest.s(element), d.s(0)); + } +} + +void CompiledVectorExpression::generateTwoArgCall(a64::Compiler& c, arm::Vec& dest, arm::Vec& arg1, arm::Vec& arg2, float (*function)(float, float)) { + arm::Gp fn = c.newIntPtr(); + c.mov(fn, imm((void*) function)); + arm::Vec a1 = c.newVecS(); + arm::Vec a2 = c.newVecS(); + arm::Vec d = c.newVecS(); + for (int element = 0; element < width; element++) { + c.ins(a1.s(0), arg1.s(element)); + c.ins(a2.s(0), arg2.s(element)); + InvokeNode* invoke; + c.invoke(&invoke, fn, FuncSignatureT()); + invoke->setArg(0, a1); + invoke->setArg(1, a2); + invoke->setRet(0, d); + c.ins(dest.s(element), d.s(0)); + } +} +#else + +void CompiledVectorExpression::generateJitCode() { + const CpuInfo& cpu = CpuInfo::host(); + if (!cpu.hasFeature(CpuFeatures::X86::kAVX)) + return; + CodeHolder code; + code.init(runtime.environment()); + x86::Compiler c(&code); + FuncNode* funcNode = c.addFunc(FuncSignatureT()); + funcNode->frame().setAvxEnabled(); + vector workspaceVar(workspace.size()/width); + for (int i = 0; i < (int) workspaceVar.size(); i++) + workspaceVar[i] = c.newYmmPs(); + x86::Gp argsPointer = c.newIntPtr(); + c.mov(argsPointer, imm(&argValues[0])); + vector > groups, groupPowers; + vector stepGroup; + findPowerGroups(groups, groupPowers, stepGroup); + + // Load the arguments into variables. + + for (set::const_iterator iter = variableNames.begin(); iter != variableNames.end(); ++iter) { + map::iterator index = variableIndices.find(*iter); + x86::Gp variablePointer = c.newIntPtr(); + c.mov(variablePointer, imm(getVariablePointer(index->first))); + if (width == 4) + c.vmovdqu(workspaceVar[index->second].xmm(), x86::ptr(variablePointer, 0, 0)); + else + c.vmovdqu(workspaceVar[index->second], x86::ptr(variablePointer, 0, 0)); + } + + // Make a list of all constants that will be needed for evaluation. + + vector operationConstantIndex(operation.size(), -1); + for (int step = 0; step < (int) operation.size(); step++) { + // Find the constant value (if any) used by this operation. + + Operation& op = *operation[step]; + double value; + if (op.getId() == Operation::CONSTANT) + value = dynamic_cast (op).getValue(); + else if (op.getId() == Operation::ADD_CONSTANT) + value = dynamic_cast (op).getValue(); + else if (op.getId() == Operation::MULTIPLY_CONSTANT) + value = dynamic_cast (op).getValue(); + else if (op.getId() == Operation::RECIPROCAL) + value = 1.0; + else if (op.getId() == Operation::STEP) + value = 1.0; + else if (op.getId() == Operation::DELTA) + value = 1.0; + else if (op.getId() == Operation::ABS) { + int mask = 0x7FFFFFFF; + value = *reinterpret_cast(&mask); + } + else if (op.getId() == Operation::POWER_CONSTANT) { + if (stepGroup[step] == -1) + value = dynamic_cast (op).getValue(); + else + value = 1.0; + } else + continue; + + // See if we already have a variable for this constant. + + for (int i = 0; i < (int) constants.size(); i++) + if (value == constants[i]) { + operationConstantIndex[step] = i; + break; + } + if (operationConstantIndex[step] == -1) { + operationConstantIndex[step] = constants.size(); + constants.push_back(value); + } + } + + // Load constants into variables. + + vector constantVar(constants.size()); + if (constants.size() > 0) { + x86::Gp constantsPointer = c.newIntPtr(); + c.mov(constantsPointer, imm(&constants[0])); + for (int i = 0; i < (int) constants.size(); i++) { + constantVar[i] = c.newYmmPs(); + c.vbroadcastss(constantVar[i], x86::ptr(constantsPointer, 4*i, 0)); + } + } + + // Evaluate the operations. + + vector hasComputedPower(operation.size(), false); + x86::Ymm argReg = c.newYmm(); + x86::Ymm doubleArgReg = c.newYmm(); + x86::Ymm doubleResultReg = c.newYmm(); + for (int step = 0; step < (int) operation.size(); step++) { + if (hasComputedPower[step]) + continue; + + // When one or more steps involve raising the same argument to multiple integer + // powers, we can compute them all together for efficiency. + + if (stepGroup[step] != -1) { + vector& group = groups[stepGroup[step]]; + vector& powers = groupPowers[stepGroup[step]]; + x86::Ymm multiplier = c.newYmmPs(); + if (powers[0] > 0) + c.vmovdqu(multiplier, workspaceVar[arguments[step][0]]); + else { + c.vdivps(multiplier, constantVar[operationConstantIndex[step]], workspaceVar[arguments[step][0]]); + for (int i = 0; i < powers.size(); i++) + powers[i] = -powers[i]; + } + vector hasAssigned(group.size(), false); + bool done = false; + while (!done) { + done = true; + for (int i = 0; i < group.size(); i++) { + if (powers[i] % 2 == 1) { + if (!hasAssigned[i]) + c.vmovdqu(workspaceVar[target[group[i]]], multiplier); + else + c.vmulps(workspaceVar[target[group[i]]], workspaceVar[target[group[i]]], multiplier); + hasAssigned[i] = true; + } + powers[i] >>= 1; + if (powers[i] != 0) + done = false; + } + if (!done) + c.vmulps(multiplier, multiplier, multiplier); + } + for (int step : group) + hasComputedPower[step] = true; + continue; + } + + // Evaluate the step. + + Operation& op = *operation[step]; + vector args = arguments[step]; + if (args.size() == 1) { + // One or more sequential arguments. Fill out the list. + + for (int i = 1; i < op.getNumArguments(); i++) + args.push_back(args[0] + i); + } + + // Generate instructions to execute this operation. + + switch (op.getId()) { + case Operation::CONSTANT: + c.vmovdqu(workspaceVar[target[step]], constantVar[operationConstantIndex[step]]); + break; + case Operation::ADD: + c.vaddps(workspaceVar[target[step]], workspaceVar[args[0]], workspaceVar[args[1]]); + break; + case Operation::SUBTRACT: + c.vsubps(workspaceVar[target[step]], workspaceVar[args[0]], workspaceVar[args[1]]); + break; + case Operation::MULTIPLY: + c.vmulps(workspaceVar[target[step]], workspaceVar[args[0]], workspaceVar[args[1]]); + break; + case Operation::DIVIDE: + c.vdivps(workspaceVar[target[step]], workspaceVar[args[0]], workspaceVar[args[1]]); + break; + case Operation::POWER: + generateTwoArgCall(c, workspaceVar[target[step]], workspaceVar[args[0]], workspaceVar[args[1]], powf); + break; + case Operation::NEGATE: + c.vxorps(workspaceVar[target[step]], workspaceVar[target[step]], workspaceVar[target[step]]); + c.vsubps(workspaceVar[target[step]], workspaceVar[target[step]], workspaceVar[args[0]]); + break; + case Operation::SQRT: + c.vsqrtps(workspaceVar[target[step]], workspaceVar[args[0]]); + break; + case Operation::EXP: + generateSingleArgCall(c, workspaceVar[target[step]], workspaceVar[args[0]], expf); + break; + case Operation::LOG: + generateSingleArgCall(c, workspaceVar[target[step]], workspaceVar[args[0]], logf); + break; + case Operation::SIN: + generateSingleArgCall(c, workspaceVar[target[step]], workspaceVar[args[0]], sinf); + break; + case Operation::COS: + generateSingleArgCall(c, workspaceVar[target[step]], workspaceVar[args[0]], cosf); + break; + case Operation::TAN: + generateSingleArgCall(c, workspaceVar[target[step]], workspaceVar[args[0]], tanf); + break; + case Operation::ASIN: + generateSingleArgCall(c, workspaceVar[target[step]], workspaceVar[args[0]], asinf); + break; + case Operation::ACOS: + generateSingleArgCall(c, workspaceVar[target[step]], workspaceVar[args[0]], acosf); + break; + case Operation::ATAN: + generateSingleArgCall(c, workspaceVar[target[step]], workspaceVar[args[0]], atanf); + break; + case Operation::ATAN2: + generateTwoArgCall(c, workspaceVar[target[step]], workspaceVar[args[0]], workspaceVar[args[1]], atan2f); + break; + case Operation::SINH: + generateSingleArgCall(c, workspaceVar[target[step]], workspaceVar[args[0]], sinhf); + break; + case Operation::COSH: + generateSingleArgCall(c, workspaceVar[target[step]], workspaceVar[args[0]], coshf); + break; + case Operation::TANH: + generateSingleArgCall(c, workspaceVar[target[step]], workspaceVar[args[0]], tanhf); + break; + case Operation::STEP: + c.vxorps(workspaceVar[target[step]], workspaceVar[target[step]], workspaceVar[target[step]]); + c.vcmpps(workspaceVar[target[step]], workspaceVar[target[step]], workspaceVar[args[0]], imm(18)); // Comparison mode is _CMP_LE_OQ = 18 + c.vandps(workspaceVar[target[step]], workspaceVar[target[step]], constantVar[operationConstantIndex[step]]); + break; + case Operation::DELTA: + c.vxorps(workspaceVar[target[step]], workspaceVar[target[step]], workspaceVar[target[step]]); + c.vcmpps(workspaceVar[target[step]], workspaceVar[target[step]], workspaceVar[args[0]], imm(16)); // Comparison mode is _CMP_EQ_OQ = 0 + c.vandps(workspaceVar[target[step]], workspaceVar[target[step]], constantVar[operationConstantIndex[step]]); + break; + case Operation::SQUARE: + c.vmulps(workspaceVar[target[step]], workspaceVar[args[0]], workspaceVar[args[0]]); + break; + case Operation::CUBE: + c.vmulps(workspaceVar[target[step]], workspaceVar[args[0]], workspaceVar[args[0]]); + c.vmulps(workspaceVar[target[step]], workspaceVar[target[step]], workspaceVar[args[0]]); + break; + case Operation::RECIPROCAL: + c.vdivps(workspaceVar[target[step]], constantVar[operationConstantIndex[step]], workspaceVar[args[0]]); + break; + case Operation::ADD_CONSTANT: + c.vaddps(workspaceVar[target[step]], workspaceVar[args[0]], constantVar[operationConstantIndex[step]]); + break; + case Operation::MULTIPLY_CONSTANT: + c.vmulps(workspaceVar[target[step]], workspaceVar[args[0]], constantVar[operationConstantIndex[step]]); + break; + case Operation::POWER_CONSTANT: + generateTwoArgCall(c, workspaceVar[target[step]], workspaceVar[args[0]], constantVar[operationConstantIndex[step]], powf); + break; + case Operation::MIN: + c.vminps(workspaceVar[target[step]], workspaceVar[args[0]], workspaceVar[args[1]]); + break; + case Operation::MAX: + c.vmaxps(workspaceVar[target[step]], workspaceVar[args[0]], workspaceVar[args[1]]); + break; + case Operation::ABS: + c.vandps(workspaceVar[target[step]], workspaceVar[args[0]], constantVar[operationConstantIndex[step]]); + break; + case Operation::FLOOR: + c.vroundps(workspaceVar[target[step]], workspaceVar[args[0]], imm(1)); + break; + case Operation::CEIL: + c.vroundps(workspaceVar[target[step]], workspaceVar[args[0]], imm(2)); + break; + case Operation::SELECT: + { + x86::Ymm mask = c.newYmmPs(); + c.vxorps(mask, mask, mask); + c.vcmpps(mask, mask, workspaceVar[args[0]], imm(0)); // Comparison mode is _CMP_EQ_OQ = 0 + c.vblendvps(workspaceVar[target[step]], workspaceVar[args[1]], workspaceVar[args[2]], mask); + break; + } + default: + // Just invoke evaluateOperation(). + + for (int element = 0; element < width; element++) { + for (int i = 0; i < (int) args.size(); i++) { + if (element < 4) + c.vshufps(argReg, workspaceVar[args[i]], workspaceVar[args[i]], imm(element)); + else { + c.vperm2f128(argReg, workspaceVar[args[i]], workspaceVar[args[i]], imm(1)); + c.vshufps(argReg, argReg, argReg, imm(element-4)); + } + c.vcvtss2sd(doubleArgReg.xmm(), doubleArgReg.xmm(), argReg.xmm()); + c.vmovsd(x86::ptr(argsPointer, 8*i, 0), doubleArgReg.xmm()); + } + x86::Gp fn = c.newIntPtr(); + c.mov(fn, imm((void*) evaluateOperation)); + InvokeNode* invoke; + c.invoke(&invoke, fn, FuncSignatureT()); + invoke->setArg(0, imm(&op)); + invoke->setArg(1, imm(&argValues[0])); + invoke->setRet(0, doubleResultReg); + c.vcvtsd2ss(argReg.xmm(), argReg.xmm(), doubleResultReg.xmm()); + if (element > 3) + c.vperm2f128(argReg, argReg, argReg, imm(0)); + if (element != 0) + c.vshufps(argReg, argReg, argReg, imm(0)); + c.vblendps(workspaceVar[target[step]], workspaceVar[target[step]], argReg, 1<()); + invoke->setArg(0, a); + invoke->setRet(0, d); + if (element > 3) + c.vperm2f128(d, d, d, imm(0)); + if (element != 0) + c.vshufps(d, d, d, imm(0)); + c.vblendps(dest, dest, d, 1<()); + invoke->setArg(0, a1); + invoke->setArg(1, a2); + invoke->setRet(0, d); + if (element > 3) + c.vperm2f128(d, d, d, imm(0)); + if (element != 0) + c.vshufps(d, d, d, imm(0)); + c.vblendps(dest, dest, d, 1< using namespace Lepton; using namespace std; @@ -62,6 +63,11 @@ ExpressionTreeNode::ExpressionTreeNode(Operation* operation) : operation(operati ExpressionTreeNode::ExpressionTreeNode(const ExpressionTreeNode& node) : operation(node.operation == NULL ? NULL : node.operation->clone()), children(node.getChildren()) { } +ExpressionTreeNode::ExpressionTreeNode(ExpressionTreeNode&& node) : operation(node.operation), children(move(node.children)) { + node.operation = NULL; + node.children.clear(); +} + ExpressionTreeNode::ExpressionTreeNode() : operation(NULL) { } @@ -98,6 +104,16 @@ ExpressionTreeNode& ExpressionTreeNode::operator=(const ExpressionTreeNode& node return *this; } +ExpressionTreeNode& ExpressionTreeNode::operator=(ExpressionTreeNode&& node) { + if (operation != NULL) + delete operation; + operation = node.operation; + children = move(node.children); + node.operation = NULL; + node.children.clear(); + return *this; +} + const Operation& ExpressionTreeNode::getOperation() const { return *operation; } @@ -105,3 +121,33 @@ const Operation& ExpressionTreeNode::getOperation() const { const vector& ExpressionTreeNode::getChildren() const { return children; } + +void ExpressionTreeNode::assignTags(vector& examples) const { + // Assign tag values to all nodes in a tree, such that two nodes have the same + // tag if and only if they (and all their children) are equal. This is used to + // optimize other operations. + + int numTags = examples.size(); + for (const ExpressionTreeNode& child : getChildren()) + child.assignTags(examples); + if (numTags == examples.size()) { + // All the children matched existing tags, so possibly this node does too. + + for (int i = 0; i < examples.size(); i++) { + const ExpressionTreeNode& example = *examples[i]; + bool matches = (getChildren().size() == example.getChildren().size() && getOperation() == example.getOperation()); + for (int j = 0; matches && j < getChildren().size(); j++) + if (getChildren()[j].tag != example.getChildren()[j].tag) + matches = false; + if (matches) { + tag = i; + return; + } + } + } + + // This node does not match any previous node, so assign a new tag. + + tag = examples.size(); + examples.push_back(this); +} diff --git a/lib/colvars/lepton/src/MSVC_erfc.h b/lib/colvars/lepton/src/MSVC_erfc.h index b1cd87a289..2c6b619e89 100644 --- a/lib/colvars/lepton/src/MSVC_erfc.h +++ b/lib/colvars/lepton/src/MSVC_erfc.h @@ -3,7 +3,7 @@ /* * Up to version 11 (VC++ 2012), Microsoft does not support the - * standard C99 erf() and erfc() functions so we have to fake them here. + * standard C99 erf() and erfc() functions so we have to fake them here. * These were added in version 12 (VC++ 2013), which sets _MSC_VER=1800 * (VC11 has _MSC_VER=1700). */ @@ -15,7 +15,7 @@ #endif #if defined(_MSC_VER) -#if _MSC_VER <= 1700 // 1700 is VC11, 1800 is VC12 +#if _MSC_VER <= 1700 // 1700 is VC11, 1800 is VC12 /*************************** * erf.cpp * author: Steve Strand diff --git a/lib/colvars/lepton/src/Operation.cpp b/lib/colvars/lepton/src/Operation.cpp index 78741c4814..b5a958b2f7 100644 --- a/lib/colvars/lepton/src/Operation.cpp +++ b/lib/colvars/lepton/src/Operation.cpp @@ -7,7 +7,7 @@ * Biological Structures at Stanford, funded under the NIH Roadmap for * * Medical Research, grant U54 GM072970. See https://simtk.org. * * * - * Portions copyright (c) 2009-2019 Stanford University and the Authors. * + * Portions copyright (c) 2009-2021 Stanford University and the Authors. * * Authors: Peter Eastman * * Contributors: * * * @@ -37,6 +37,12 @@ using namespace Lepton; using namespace std; +static bool isZero(const ExpressionTreeNode& node) { + if (node.getOperation().getId() != Operation::CONSTANT) + return false; + return dynamic_cast(node.getOperation()).getValue() == 0.0; +} + double Operation::Erf::evaluate(double* args, const map& variables) const { return erf(args[0]); } @@ -58,35 +64,71 @@ ExpressionTreeNode Operation::Variable::differentiate(const std::vector& children, const std::vector& childDerivs, const std::string& variable) const { if (function->getNumArguments() == 0) return ExpressionTreeNode(new Operation::Constant(0.0)); - ExpressionTreeNode result = ExpressionTreeNode(new Operation::Multiply(), ExpressionTreeNode(new Operation::Custom(*this, 0), children), childDerivs[0]); - for (int i = 1; i < getNumArguments(); i++) { - result = ExpressionTreeNode(new Operation::Add(), - result, - ExpressionTreeNode(new Operation::Multiply(), ExpressionTreeNode(new Operation::Custom(*this, i), children), childDerivs[i])); + ExpressionTreeNode result; + bool foundTerm = false; + for (int i = 0; i < getNumArguments(); i++) { + if (!isZero(childDerivs[i])) { + if (foundTerm) + result = ExpressionTreeNode(new Operation::Add(), + result, + ExpressionTreeNode(new Operation::Multiply(), ExpressionTreeNode(new Operation::Custom(*this, i), children), childDerivs[i])); + else { + result = ExpressionTreeNode(new Operation::Multiply(), ExpressionTreeNode(new Operation::Custom(*this, i), children), childDerivs[i]); + foundTerm = true; + } + } } - return result; + if (foundTerm) + return result; + return ExpressionTreeNode(new Operation::Constant(0.0)); } ExpressionTreeNode Operation::Add::differentiate(const std::vector& children, const std::vector& childDerivs, const std::string& variable) const { + if (isZero(childDerivs[0])) + return childDerivs[1]; + if (isZero(childDerivs[1])) + return childDerivs[0]; return ExpressionTreeNode(new Operation::Add(), childDerivs[0], childDerivs[1]); } ExpressionTreeNode Operation::Subtract::differentiate(const std::vector& children, const std::vector& childDerivs, const std::string& variable) const { + if (isZero(childDerivs[0])) { + if (isZero(childDerivs[1])) + return ExpressionTreeNode(new Operation::Constant(0.0)); + return ExpressionTreeNode(new Operation::Negate(), childDerivs[1]); + } + if (isZero(childDerivs[1])) + return childDerivs[0]; return ExpressionTreeNode(new Operation::Subtract(), childDerivs[0], childDerivs[1]); } ExpressionTreeNode Operation::Multiply::differentiate(const std::vector& children, const std::vector& childDerivs, const std::string& variable) const { + if (isZero(childDerivs[0])) { + if (isZero(childDerivs[1])) + return ExpressionTreeNode(new Operation::Constant(0.0)); + return ExpressionTreeNode(new Operation::Multiply(), children[0], childDerivs[1]); + } + if (isZero(childDerivs[1])) + return ExpressionTreeNode(new Operation::Multiply(), children[1], childDerivs[0]); return ExpressionTreeNode(new Operation::Add(), ExpressionTreeNode(new Operation::Multiply(), children[0], childDerivs[1]), ExpressionTreeNode(new Operation::Multiply(), children[1], childDerivs[0])); } ExpressionTreeNode Operation::Divide::differentiate(const std::vector& children, const std::vector& childDerivs, const std::string& variable) const { - return ExpressionTreeNode(new Operation::Divide(), - ExpressionTreeNode(new Operation::Subtract(), + ExpressionTreeNode subexp; + if (isZero(childDerivs[0])) { + if (isZero(childDerivs[1])) + return ExpressionTreeNode(new Operation::Constant(0.0)); + subexp = ExpressionTreeNode(new Operation::Negate(), ExpressionTreeNode(new Operation::Multiply(), children[0], childDerivs[1])); + } + else if (isZero(childDerivs[1])) + subexp = ExpressionTreeNode(new Operation::Multiply(), children[1], childDerivs[0]); + else + subexp = ExpressionTreeNode(new Operation::Subtract(), ExpressionTreeNode(new Operation::Multiply(), children[1], childDerivs[0]), - ExpressionTreeNode(new Operation::Multiply(), children[0], childDerivs[1])), - ExpressionTreeNode(new Operation::Square(), children[1])); + ExpressionTreeNode(new Operation::Multiply(), children[0], childDerivs[1])); + return ExpressionTreeNode(new Operation::Divide(), subexp, ExpressionTreeNode(new Operation::Square(), children[1])); } ExpressionTreeNode Operation::Power::differentiate(const std::vector& children, const std::vector& childDerivs, const std::string& variable) const { @@ -105,10 +147,14 @@ ExpressionTreeNode Operation::Power::differentiate(const std::vector& children, const std::vector& childDerivs, const std::string& variable) const { + if (isZero(childDerivs[0])) + return ExpressionTreeNode(new Operation::Constant(0.0)); return ExpressionTreeNode(new Operation::Negate(), childDerivs[0]); } ExpressionTreeNode Operation::Sqrt::differentiate(const std::vector& children, const std::vector& childDerivs, const std::string& variable) const { + if (isZero(childDerivs[0])) + return ExpressionTreeNode(new Operation::Constant(0.0)); return ExpressionTreeNode(new Operation::Multiply(), ExpressionTreeNode(new Operation::MultiplyConstant(0.5), ExpressionTreeNode(new Operation::Reciprocal(), @@ -117,24 +163,32 @@ ExpressionTreeNode Operation::Sqrt::differentiate(const std::vector& children, const std::vector& childDerivs, const std::string& variable) const { + if (isZero(childDerivs[0])) + return ExpressionTreeNode(new Operation::Constant(0.0)); return ExpressionTreeNode(new Operation::Multiply(), ExpressionTreeNode(new Operation::Exp(), children[0]), childDerivs[0]); } ExpressionTreeNode Operation::Log::differentiate(const std::vector& children, const std::vector& childDerivs, const std::string& variable) const { + if (isZero(childDerivs[0])) + return ExpressionTreeNode(new Operation::Constant(0.0)); return ExpressionTreeNode(new Operation::Multiply(), ExpressionTreeNode(new Operation::Reciprocal(), children[0]), childDerivs[0]); } ExpressionTreeNode Operation::Sin::differentiate(const std::vector& children, const std::vector& childDerivs, const std::string& variable) const { + if (isZero(childDerivs[0])) + return ExpressionTreeNode(new Operation::Constant(0.0)); return ExpressionTreeNode(new Operation::Multiply(), ExpressionTreeNode(new Operation::Cos(), children[0]), childDerivs[0]); } ExpressionTreeNode Operation::Cos::differentiate(const std::vector& children, const std::vector& childDerivs, const std::string& variable) const { + if (isZero(childDerivs[0])) + return ExpressionTreeNode(new Operation::Constant(0.0)); return ExpressionTreeNode(new Operation::Multiply(), ExpressionTreeNode(new Operation::Negate(), ExpressionTreeNode(new Operation::Sin(), children[0])), @@ -142,6 +196,8 @@ ExpressionTreeNode Operation::Cos::differentiate(const std::vector& children, const std::vector& childDerivs, const std::string& variable) const { + if (isZero(childDerivs[0])) + return ExpressionTreeNode(new Operation::Constant(0.0)); return ExpressionTreeNode(new Operation::Multiply(), ExpressionTreeNode(new Operation::Multiply(), ExpressionTreeNode(new Operation::Sec(), children[0]), @@ -150,6 +206,8 @@ ExpressionTreeNode Operation::Sec::differentiate(const std::vector& children, const std::vector& childDerivs, const std::string& variable) const { + if (isZero(childDerivs[0])) + return ExpressionTreeNode(new Operation::Constant(0.0)); return ExpressionTreeNode(new Operation::Multiply(), ExpressionTreeNode(new Operation::Negate(), ExpressionTreeNode(new Operation::Multiply(), @@ -159,6 +217,8 @@ ExpressionTreeNode Operation::Csc::differentiate(const std::vector& children, const std::vector& childDerivs, const std::string& variable) const { + if (isZero(childDerivs[0])) + return ExpressionTreeNode(new Operation::Constant(0.0)); return ExpressionTreeNode(new Operation::Multiply(), ExpressionTreeNode(new Operation::Square(), ExpressionTreeNode(new Operation::Sec(), children[0])), @@ -166,6 +226,8 @@ ExpressionTreeNode Operation::Tan::differentiate(const std::vector& children, const std::vector& childDerivs, const std::string& variable) const { + if (isZero(childDerivs[0])) + return ExpressionTreeNode(new Operation::Constant(0.0)); return ExpressionTreeNode(new Operation::Multiply(), ExpressionTreeNode(new Operation::Negate(), ExpressionTreeNode(new Operation::Square(), @@ -174,6 +236,8 @@ ExpressionTreeNode Operation::Cot::differentiate(const std::vector& children, const std::vector& childDerivs, const std::string& variable) const { + if (isZero(childDerivs[0])) + return ExpressionTreeNode(new Operation::Constant(0.0)); return ExpressionTreeNode(new Operation::Multiply(), ExpressionTreeNode(new Operation::Reciprocal(), ExpressionTreeNode(new Operation::Sqrt(), @@ -184,6 +248,8 @@ ExpressionTreeNode Operation::Asin::differentiate(const std::vector& children, const std::vector& childDerivs, const std::string& variable) const { + if (isZero(childDerivs[0])) + return ExpressionTreeNode(new Operation::Constant(0.0)); return ExpressionTreeNode(new Operation::Multiply(), ExpressionTreeNode(new Operation::Negate(), ExpressionTreeNode(new Operation::Reciprocal(), @@ -195,6 +261,8 @@ ExpressionTreeNode Operation::Acos::differentiate(const std::vector& children, const std::vector& childDerivs, const std::string& variable) const { + if (isZero(childDerivs[0])) + return ExpressionTreeNode(new Operation::Constant(0.0)); return ExpressionTreeNode(new Operation::Multiply(), ExpressionTreeNode(new Operation::Reciprocal(), ExpressionTreeNode(new Operation::AddConstant(1.0), @@ -213,6 +281,8 @@ ExpressionTreeNode Operation::Atan2::differentiate(const std::vector& children, const std::vector& childDerivs, const std::string& variable) const { + if (isZero(childDerivs[0])) + return ExpressionTreeNode(new Operation::Constant(0.0)); return ExpressionTreeNode(new Operation::Multiply(), ExpressionTreeNode(new Operation::Cosh(), children[0]), @@ -220,6 +290,8 @@ ExpressionTreeNode Operation::Sinh::differentiate(const std::vector& children, const std::vector& childDerivs, const std::string& variable) const { + if (isZero(childDerivs[0])) + return ExpressionTreeNode(new Operation::Constant(0.0)); return ExpressionTreeNode(new Operation::Multiply(), ExpressionTreeNode(new Operation::Sinh(), children[0]), @@ -227,6 +299,8 @@ ExpressionTreeNode Operation::Cosh::differentiate(const std::vector& children, const std::vector& childDerivs, const std::string& variable) const { + if (isZero(childDerivs[0])) + return ExpressionTreeNode(new Operation::Constant(0.0)); return ExpressionTreeNode(new Operation::Multiply(), ExpressionTreeNode(new Operation::Subtract(), ExpressionTreeNode(new Operation::Constant(1.0)), @@ -236,6 +310,8 @@ ExpressionTreeNode Operation::Tanh::differentiate(const std::vector& children, const std::vector& childDerivs, const std::string& variable) const { + if (isZero(childDerivs[0])) + return ExpressionTreeNode(new Operation::Constant(0.0)); return ExpressionTreeNode(new Operation::Multiply(), ExpressionTreeNode(new Operation::Multiply(), ExpressionTreeNode(new Operation::Constant(2.0/sqrt(M_PI))), @@ -246,6 +322,8 @@ ExpressionTreeNode Operation::Erf::differentiate(const std::vector& children, const std::vector& childDerivs, const std::string& variable) const { + if (isZero(childDerivs[0])) + return ExpressionTreeNode(new Operation::Constant(0.0)); return ExpressionTreeNode(new Operation::Multiply(), ExpressionTreeNode(new Operation::Multiply(), ExpressionTreeNode(new Operation::Constant(-2.0/sqrt(M_PI))), @@ -264,6 +342,8 @@ ExpressionTreeNode Operation::Delta::differentiate(const std::vector& children, const std::vector& childDerivs, const std::string& variable) const { + if (isZero(childDerivs[0])) + return ExpressionTreeNode(new Operation::Constant(0.0)); return ExpressionTreeNode(new Operation::Multiply(), ExpressionTreeNode(new Operation::MultiplyConstant(2.0), children[0]), @@ -271,6 +351,8 @@ ExpressionTreeNode Operation::Square::differentiate(const std::vector& children, const std::vector& childDerivs, const std::string& variable) const { + if (isZero(childDerivs[0])) + return ExpressionTreeNode(new Operation::Constant(0.0)); return ExpressionTreeNode(new Operation::Multiply(), ExpressionTreeNode(new Operation::MultiplyConstant(3.0), ExpressionTreeNode(new Operation::Square(), children[0])), @@ -278,6 +360,8 @@ ExpressionTreeNode Operation::Cube::differentiate(const std::vector& children, const std::vector& childDerivs, const std::string& variable) const { + if (isZero(childDerivs[0])) + return ExpressionTreeNode(new Operation::Constant(0.0)); return ExpressionTreeNode(new Operation::Multiply(), ExpressionTreeNode(new Operation::Negate(), ExpressionTreeNode(new Operation::Reciprocal(), @@ -290,11 +374,15 @@ ExpressionTreeNode Operation::AddConstant::differentiate(const std::vector& children, const std::vector& childDerivs, const std::string& variable) const { + if (isZero(childDerivs[0])) + return ExpressionTreeNode(new Operation::Constant(0.0)); return ExpressionTreeNode(new Operation::MultiplyConstant(value), childDerivs[0]); } ExpressionTreeNode Operation::PowerConstant::differentiate(const std::vector& children, const std::vector& childDerivs, const std::string& variable) const { + if (isZero(childDerivs[0])) + return ExpressionTreeNode(new Operation::Constant(0.0)); return ExpressionTreeNode(new Operation::Multiply(), ExpressionTreeNode(new Operation::MultiplyConstant(value), ExpressionTreeNode(new Operation::PowerConstant(value-1), @@ -305,22 +393,18 @@ ExpressionTreeNode Operation::PowerConstant::differentiate(const std::vector& children, const std::vector& childDerivs, const std::string& variable) const { ExpressionTreeNode step(new Operation::Step(), ExpressionTreeNode(new Operation::Subtract(), children[0], children[1])); - return ExpressionTreeNode(new Operation::Subtract(), - ExpressionTreeNode(new Operation::Multiply(), childDerivs[1], step), - ExpressionTreeNode(new Operation::Multiply(), childDerivs[0], - ExpressionTreeNode(new Operation::AddConstant(-1), step))); + return ExpressionTreeNode(new Operation::Select(), {step, childDerivs[1], childDerivs[0]}); } ExpressionTreeNode Operation::Max::differentiate(const std::vector& children, const std::vector& childDerivs, const std::string& variable) const { ExpressionTreeNode step(new Operation::Step(), ExpressionTreeNode(new Operation::Subtract(), children[0], children[1])); - return ExpressionTreeNode(new Operation::Subtract(), - ExpressionTreeNode(new Operation::Multiply(), childDerivs[0], step), - ExpressionTreeNode(new Operation::Multiply(), childDerivs[1], - ExpressionTreeNode(new Operation::AddConstant(-1), step))); + return ExpressionTreeNode(new Operation::Select(), {step, childDerivs[0], childDerivs[1]}); } ExpressionTreeNode Operation::Abs::differentiate(const std::vector& children, const std::vector& childDerivs, const std::string& variable) const { + if (isZero(childDerivs[0])) + return ExpressionTreeNode(new Operation::Constant(0.0)); ExpressionTreeNode step(new Operation::Step(), children[0]); return ExpressionTreeNode(new Operation::Multiply(), childDerivs[0], @@ -337,9 +421,5 @@ ExpressionTreeNode Operation::Ceil::differentiate(const std::vector& children, const std::vector& childDerivs, const std::string& variable) const { - vector derivChildren; - derivChildren.push_back(children[0]); - derivChildren.push_back(childDerivs[1]); - derivChildren.push_back(childDerivs[2]); - return ExpressionTreeNode(new Operation::Select(), derivChildren); + return ExpressionTreeNode(new Operation::Select(), {children[0], childDerivs[1], childDerivs[2]}); } diff --git a/lib/colvars/lepton/src/ParsedExpression.cpp b/lib/colvars/lepton/src/ParsedExpression.cpp index fd3b091d3c..f3f18fccd2 100644 --- a/lib/colvars/lepton/src/ParsedExpression.cpp +++ b/lib/colvars/lepton/src/ParsedExpression.cpp @@ -6,7 +6,7 @@ * Biological Structures at Stanford, funded under the NIH Roadmap for * * Medical Research, grant U54 GM072970. See https://simtk.org. * * * - * Portions copyright (c) 2009 Stanford University and the Authors. * + * Portions copyright (c) 2009-2022 Stanford University and the Authors. * * Authors: Peter Eastman * * Contributors: * * * @@ -31,6 +31,7 @@ #include "lepton/ParsedExpression.h" #include "lepton/CompiledExpression.h" +#include "lepton/CompiledVectorExpression.h" #include "lepton/ExpressionProgram.h" #include "lepton/Operation.h" #include @@ -68,9 +69,16 @@ double ParsedExpression::evaluate(const ExpressionTreeNode& node, const map examples; + result.assignTags(examples); + map nodeCache; + result = precalculateConstantSubexpressions(result, nodeCache); while (true) { - ExpressionTreeNode simplified = substituteSimplerExpression(result); + examples.clear(); + result.assignTags(examples); + nodeCache.clear(); + ExpressionTreeNode simplified = substituteSimplerExpression(result, nodeCache); if (simplified == result) break; result = simplified; @@ -80,9 +88,15 @@ ParsedExpression ParsedExpression::optimize() const { ParsedExpression ParsedExpression::optimize(const map& variables) const { ExpressionTreeNode result = preevaluateVariables(getRootNode(), variables); - result = precalculateConstantSubexpressions(result); + vector examples; + result.assignTags(examples); + map nodeCache; + result = precalculateConstantSubexpressions(result, nodeCache); while (true) { - ExpressionTreeNode simplified = substituteSimplerExpression(result); + examples.clear(); + result.assignTags(examples); + nodeCache.clear(); + ExpressionTreeNode simplified = substituteSimplerExpression(result, nodeCache); if (simplified == result) break; result = simplified; @@ -104,36 +118,67 @@ ExpressionTreeNode ParsedExpression::preevaluateVariables(const ExpressionTreeNo return ExpressionTreeNode(node.getOperation().clone(), children); } -ExpressionTreeNode ParsedExpression::precalculateConstantSubexpressions(const ExpressionTreeNode& node) { +ExpressionTreeNode ParsedExpression::precalculateConstantSubexpressions(const ExpressionTreeNode& node, map& nodeCache) { + auto cached = nodeCache.find(node.tag); + if (cached != nodeCache.end()) + return cached->second; vector children(node.getChildren().size()); for (int i = 0; i < (int) children.size(); i++) - children[i] = precalculateConstantSubexpressions(node.getChildren()[i]); + children[i] = precalculateConstantSubexpressions(node.getChildren()[i], nodeCache); ExpressionTreeNode result = ExpressionTreeNode(node.getOperation().clone(), children); - if (node.getOperation().getId() == Operation::VARIABLE || node.getOperation().getId() == Operation::CUSTOM) + if (node.getOperation().getId() == Operation::VARIABLE || node.getOperation().getId() == Operation::CUSTOM) { + nodeCache[node.tag] = result; return result; + } for (int i = 0; i < (int) children.size(); i++) - if (children[i].getOperation().getId() != Operation::CONSTANT) + if (children[i].getOperation().getId() != Operation::CONSTANT) { + nodeCache[node.tag] = result; return result; - return ExpressionTreeNode(new Operation::Constant(evaluate(result, map()))); + } + result = ExpressionTreeNode(new Operation::Constant(evaluate(result, map()))); + nodeCache[node.tag] = result; + return result; } -ExpressionTreeNode ParsedExpression::substituteSimplerExpression(const ExpressionTreeNode& node) { +ExpressionTreeNode ParsedExpression::substituteSimplerExpression(const ExpressionTreeNode& node, map& nodeCache) { vector children(node.getChildren().size()); - for (int i = 0; i < (int) children.size(); i++) - children[i] = substituteSimplerExpression(node.getChildren()[i]); + for (int i = 0; i < (int) children.size(); i++) { + const ExpressionTreeNode& child = node.getChildren()[i]; + auto cached = nodeCache.find(child.tag); + if (cached == nodeCache.end()) { + children[i] = substituteSimplerExpression(child, nodeCache); + nodeCache[child.tag] = children[i]; + } + else + children[i] = cached->second; + } + + // Collect some info on constant expressions in children + bool first_const = children.size() > 0 && isConstant(children[0]); // is first child constant? + bool second_const = children.size() > 1 && isConstant(children[1]); ; // is second child constant? + double first, second; // if yes, value of first and second child + if (first_const) + first = getConstantValue(children[0]); + if (second_const) + second = getConstantValue(children[1]); + switch (node.getOperation().getId()) { case Operation::ADD: { - double first = getConstantValue(children[0]); - double second = getConstantValue(children[1]); - if (first == 0.0) // Add 0 - return children[1]; - if (second == 0.0) // Add 0 - return children[0]; - if (first == first) // Add a constant - return ExpressionTreeNode(new Operation::AddConstant(first), children[1]); - if (second == second) // Add a constant - return ExpressionTreeNode(new Operation::AddConstant(second), children[0]); + if (first_const) { + if (first == 0.0) { // Add 0 + return children[1]; + } else { // Add a constant + return ExpressionTreeNode(new Operation::AddConstant(first), children[1]); + } + } + if (second_const) { + if (second == 0.0) { // Add 0 + return children[0]; + } else { // Add a constant + return ExpressionTreeNode(new Operation::AddConstant(second), children[0]); + } + } if (children[1].getOperation().getId() == Operation::NEGATE) // a+(-b) = a-b return ExpressionTreeNode(new Operation::Subtract(), children[0], children[1].getChildren()[0]); if (children[0].getOperation().getId() == Operation::NEGATE) // (-a)+b = b-a @@ -144,34 +189,35 @@ ExpressionTreeNode ParsedExpression::substituteSimplerExpression(const Expressio { if (children[0] == children[1]) return ExpressionTreeNode(new Operation::Constant(0.0)); // Subtracting anything from itself is 0 - double first = getConstantValue(children[0]); - if (first == 0.0) // Subtract from 0 - return ExpressionTreeNode(new Operation::Negate(), children[1]); - double second = getConstantValue(children[1]); - if (second == 0.0) // Subtract 0 - return children[0]; - if (second == second) // Subtract a constant - return ExpressionTreeNode(new Operation::AddConstant(-second), children[0]); + if (first_const) { + if (first == 0.0) // Subtract from 0 + return ExpressionTreeNode(new Operation::Negate(), children[1]); + } + if (second_const) { + if (second == 0.0) { // Subtract 0 + return children[0]; + } else { // Subtract a constant + return ExpressionTreeNode(new Operation::AddConstant(-second), children[0]); + } + } if (children[1].getOperation().getId() == Operation::NEGATE) // a-(-b) = a+b return ExpressionTreeNode(new Operation::Add(), children[0], children[1].getChildren()[0]); break; } case Operation::MULTIPLY: - { - double first = getConstantValue(children[0]); - double second = getConstantValue(children[1]); - if (first == 0.0 || second == 0.0) // Multiply by 0 + { + if ((first_const && first == 0.0) || (second_const && second == 0.0)) // Multiply by 0 return ExpressionTreeNode(new Operation::Constant(0.0)); - if (first == 1.0) // Multiply by 1 + if (first_const && first == 1.0) // Multiply by 1 return children[1]; - if (second == 1.0) // Multiply by 1 + if (second_const && second == 1.0) // Multiply by 1 return children[0]; - if (children[0].getOperation().getId() == Operation::CONSTANT) { // Multiply by a constant + if (first_const) { // Multiply by a constant if (children[1].getOperation().getId() == Operation::MULTIPLY_CONSTANT) // Combine two multiplies into a single one return ExpressionTreeNode(new Operation::MultiplyConstant(first*dynamic_cast(&children[1].getOperation())->getValue()), children[1].getChildren()[0]); return ExpressionTreeNode(new Operation::MultiplyConstant(first), children[1]); } - if (children[1].getOperation().getId() == Operation::CONSTANT) { // Multiply by a constant + if (second_const) { // Multiply by a constant if (children[0].getOperation().getId() == Operation::MULTIPLY_CONSTANT) // Combine two multiplies into a single one return ExpressionTreeNode(new Operation::MultiplyConstant(second*dynamic_cast(&children[0].getOperation())->getValue()), children[0].getChildren()[0]); return ExpressionTreeNode(new Operation::MultiplyConstant(second), children[0]); @@ -202,18 +248,16 @@ ExpressionTreeNode ParsedExpression::substituteSimplerExpression(const Expressio { if (children[0] == children[1]) return ExpressionTreeNode(new Operation::Constant(1.0)); // Dividing anything from itself is 0 - double numerator = getConstantValue(children[0]); - if (numerator == 0.0) // 0 divided by something + if (first_const && first == 0.0) // 0 divided by something return ExpressionTreeNode(new Operation::Constant(0.0)); - if (numerator == 1.0) // 1 divided by something + if (first_const && first == 1.0) // 1 divided by something return ExpressionTreeNode(new Operation::Reciprocal(), children[1]); - double denominator = getConstantValue(children[1]); - if (denominator == 1.0) // Divide by 1 + if (second_const && second == 1.0) // Divide by 1 return children[0]; - if (children[1].getOperation().getId() == Operation::CONSTANT) { + if (second_const) { if (children[0].getOperation().getId() == Operation::MULTIPLY_CONSTANT) // Combine a multiply and a divide into one multiply - return ExpressionTreeNode(new Operation::MultiplyConstant(dynamic_cast(&children[0].getOperation())->getValue()/denominator), children[0].getChildren()[0]); - return ExpressionTreeNode(new Operation::MultiplyConstant(1.0/denominator), children[0]); // Replace a divide with a multiply + return ExpressionTreeNode(new Operation::MultiplyConstant(dynamic_cast(&children[0].getOperation())->getValue()/second), children[0].getChildren()[0]); + return ExpressionTreeNode(new Operation::MultiplyConstant(1.0/second), children[0]); // Replace a divide with a multiply } if (children[0].getOperation().getId() == Operation::NEGATE && children[1].getOperation().getId() == Operation::NEGATE) // The two negations cancel return ExpressionTreeNode(new Operation::Divide(), children[0].getChildren()[0], children[1].getChildren()[0]); @@ -229,34 +273,34 @@ ExpressionTreeNode ParsedExpression::substituteSimplerExpression(const Expressio } case Operation::POWER: { - double base = getConstantValue(children[0]); - if (base == 0.0) // 0 to any power is 0 + if (first_const && first == 0.0) // 0 to any power is 0 return ExpressionTreeNode(new Operation::Constant(0.0)); - if (base == 1.0) // 1 to any power is 1 + if (first_const && first == 1.0) // 1 to any power is 1 return ExpressionTreeNode(new Operation::Constant(1.0)); - double exponent = getConstantValue(children[1]); - if (exponent == 0.0) // x^0 = 1 - return ExpressionTreeNode(new Operation::Constant(1.0)); - if (exponent == 1.0) // x^1 = x - return children[0]; - if (exponent == -1.0) // x^-1 = recip(x) - return ExpressionTreeNode(new Operation::Reciprocal(), children[0]); - if (exponent == 2.0) // x^2 = square(x) - return ExpressionTreeNode(new Operation::Square(), children[0]); - if (exponent == 3.0) // x^3 = cube(x) - return ExpressionTreeNode(new Operation::Cube(), children[0]); - if (exponent == 0.5) // x^0.5 = sqrt(x) - return ExpressionTreeNode(new Operation::Sqrt(), children[0]); - if (exponent == exponent) // Constant power - return ExpressionTreeNode(new Operation::PowerConstant(exponent), children[0]); + if (second_const) { // Constant exponent + if (second == 0.0) // x^0 = 1 + return ExpressionTreeNode(new Operation::Constant(1.0)); + if (second == 1.0) // x^1 = x + return children[0]; + if (second == -1.0) // x^-1 = recip(x) + return ExpressionTreeNode(new Operation::Reciprocal(), children[0]); + if (second == 2.0) // x^2 = square(x) + return ExpressionTreeNode(new Operation::Square(), children[0]); + if (second == 3.0) // x^3 = cube(x) + return ExpressionTreeNode(new Operation::Cube(), children[0]); + if (second == 0.5) // x^0.5 = sqrt(x) + return ExpressionTreeNode(new Operation::Sqrt(), children[0]); + // Constant power + return ExpressionTreeNode(new Operation::PowerConstant(second), children[0]); + } break; } case Operation::NEGATE: { if (children[0].getOperation().getId() == Operation::MULTIPLY_CONSTANT) // Combine a multiply and a negate into a single multiply return ExpressionTreeNode(new Operation::MultiplyConstant(-dynamic_cast(&children[0].getOperation())->getValue()), children[0].getChildren()[0]); - if (children[0].getOperation().getId() == Operation::CONSTANT) // Negate a constant - return ExpressionTreeNode(new Operation::Constant(-getConstantValue(children[0]))); + if (first_const) // Negate a constant + return ExpressionTreeNode(new Operation::Constant(-first)); if (children[0].getOperation().getId() == Operation::NEGATE) // The two negations cancel return children[0].getChildren()[0]; break; @@ -265,7 +309,7 @@ ExpressionTreeNode ParsedExpression::substituteSimplerExpression(const Expressio { if (children[0].getOperation().getId() == Operation::MULTIPLY_CONSTANT) // Combine two multiplies into a single one return ExpressionTreeNode(new Operation::MultiplyConstant(dynamic_cast(&node.getOperation())->getValue()*dynamic_cast(&children[0].getOperation())->getValue()), children[0].getChildren()[0]); - if (children[0].getOperation().getId() == Operation::CONSTANT) // Multiply two constants + if (first_const) // Multiply two constants return ExpressionTreeNode(new Operation::Constant(dynamic_cast(&node.getOperation())->getValue()*getConstantValue(children[0]))); if (children[0].getOperation().getId() == Operation::NEGATE) // Combine a multiply and a negate into a single multiply return ExpressionTreeNode(new Operation::MultiplyConstant(-dynamic_cast(&node.getOperation())->getValue()), children[0].getChildren()[0]); @@ -293,20 +337,33 @@ ExpressionTreeNode ParsedExpression::substituteSimplerExpression(const Expressio } ParsedExpression ParsedExpression::differentiate(const string& variable) const { - return differentiate(getRootNode(), variable); + vector examples; + getRootNode().assignTags(examples); + map nodeCache; + return differentiate(getRootNode(), variable, nodeCache); } -ExpressionTreeNode ParsedExpression::differentiate(const ExpressionTreeNode& node, const string& variable) { +ExpressionTreeNode ParsedExpression::differentiate(const ExpressionTreeNode& node, const string& variable, map& nodeCache) { + auto cached = nodeCache.find(node.tag); + if (cached != nodeCache.end()) + return cached->second; vector childDerivs(node.getChildren().size()); for (int i = 0; i < (int) childDerivs.size(); i++) - childDerivs[i] = differentiate(node.getChildren()[i], variable); - return node.getOperation().differentiate(node.getChildren(),childDerivs, variable); + childDerivs[i] = differentiate(node.getChildren()[i], variable, nodeCache); + ExpressionTreeNode result = node.getOperation().differentiate(node.getChildren(), childDerivs, variable); + nodeCache[node.tag] = result; + return result; +} + +bool ParsedExpression::isConstant(const ExpressionTreeNode& node) { + return (node.getOperation().getId() == Operation::CONSTANT); } double ParsedExpression::getConstantValue(const ExpressionTreeNode& node) { - if (node.getOperation().getId() == Operation::CONSTANT) - return dynamic_cast(node.getOperation()).getValue(); - return numeric_limits::quiet_NaN(); + if (node.getOperation().getId() != Operation::CONSTANT) { + throw Exception("getConstantValue called on a non-constant ExpressionNode"); + } + return dynamic_cast(node.getOperation()).getValue(); } ExpressionProgram ParsedExpression::createProgram() const { @@ -317,6 +374,10 @@ CompiledExpression ParsedExpression::createCompiledExpression() const { return CompiledExpression(*this); } +CompiledVectorExpression ParsedExpression::createCompiledVectorExpression(int width) const { + return CompiledVectorExpression(*this, width); +} + ParsedExpression ParsedExpression::renameVariables(const map& replacements) const { return ParsedExpression(renameNodeVariables(getRootNode(), replacements)); } diff --git a/lib/colvars/lepton/src/Parser.cpp b/lib/colvars/lepton/src/Parser.cpp index e284add258..47ebac464a 100644 --- a/lib/colvars/lepton/src/Parser.cpp +++ b/lib/colvars/lepton/src/Parser.cpp @@ -66,7 +66,7 @@ private: string Parser::trim(const string& expression) { // Remove leading and trailing spaces. - + int start, end; for (start = 0; start < (int) expression.size() && isspace(expression[start]); start++) ; From 6c375ffade2a753e8d9937932246b536683ab8a6 Mon Sep 17 00:00:00 2001 From: Giacomo Fiorin Date: Thu, 2 Jun 2022 11:48:19 -0400 Subject: [PATCH 291/585] Update PDF Colvars manual --- doc/src/PDF/colvars-refman-lammps.pdf | Bin 1490159 -> 1492597 bytes 1 file changed, 0 insertions(+), 0 deletions(-) diff --git a/doc/src/PDF/colvars-refman-lammps.pdf b/doc/src/PDF/colvars-refman-lammps.pdf index c87ccbad75a3c8a7e0ed46c69af5b0be057fb44f..59d12f925349e610767d251b9a71dffcaf0d9d24 100644 GIT binary patch delta 205863 zcmZU(V~}RSwys;YZQHhOcG*Uk?XPURx{NN{wr$(Cd3&$5Z=4fxBJ;-_V`gT|n2IOg zcig;bKSk@*=D-1SH{`-`0|R=+cThBfDHtBkH)sHh6&hnY7gjLd0@V{&eggjB1yi%z|irvO5zoZW*?t?FFEHYAjT zJ?$4nRXwySj^CeV3z&mB1H~Xj(si(WG!JH~Z8%Bu@#)gK?{GJZnkT-!3&Jy!7%0>z z8|RN4$(3F3q{`e9gaBN{ttYF=$CCU+Hz)2V@KLj_GTorf(upV2ZOY>ufLqlk11{y< zrl)n+S~7#%x{VP~S0y%F_@(9MROR?X6=H@jC(}~(BjWEkAMuYy#ow=9Z>8COZ#jPM z0AE>h-?)U4H6QbF)p)84^7a{JAS1w=8`L}GF)5!EjG3LObCMb&A}~jqG(9LyP#j`Q z93n7wAP5UfTHhi9YD-rFupDHX6FUl83w{RhG$cF|45OTxorQ}f5ep|<8c_x?HK0jb z$9}UJ#c#);Z{(O5Wej^8hSWcaP2OLXE!^2Z2lY_68C|Euo7wG%?d|1Dg4gXJYn7Hv zWzJt;=JVBxD+@NvW=wN{V~_BAhQeZC8vEq$)37+7W1olTfcQbgEXDz8j`#1;y%tK* zEX>O_C74(G8xRF1D0=PzB9+DYfk~9ND`dSgy*O+NW zuCSsdgoTp`;I^1c0$0w+s*oDnIm9^2m8EQmaNzQl1lO|L$Gz<1ice27%2@3ZYdF|IqYvHB_bd+lNgVv zRBTiDSUa{Yt;m!SjOfB>(l73y6goN&YAbc0lFo&Bs_idu97qlW9clDH1f(hwFR2t` zdUOPaZ*(?RoNV-(N1u!tAg0$DO*)4;w*!>z%0YG(G`xCPgh*q;3TR{ys+`sur4dTY zcBZQjeK-6t#HTu7T!RP3xyG}kkByb{H9j}swC61Lv-4Zm%N_r@(%P|IR;v^_BFLar z#1Q;yep{_#oNV5D+9=j}>Bya`w%@Szwo}hE^LFd9X+HjZXxDPJ=#V6J`08q1saUY> z(B&{+sjN=*;DLyJ1~|+xWIlxe`K{W_XgfD+-MpJ`0dV)+JQn*hmzG=^3qK~7KbzLR ztvCqfOs4IG?6nAbWxYGorrese+%1l4%-cTqQ4yo3KjwbUm+4J;yfoJkc?ImN->*%6 zyL>KGuPycXv|G1qmFvA6d$tTA(QQb#^cRfng7!|ItLQO)0IqeF+&pIKrp#I{I59WO z*^T?MyXJ~cuEOl-=Q~&3PI$Gb8s3FXm;Ub5cvt4G>5e5a#uNSkHJ&d`WGd4deIwfg zeVQ~}{aG;cwlvG~d%L(gZsfj7)%#h?0(IEP)}Nq_Bh)nsQO@Rh>%7iX^iHw4i`keO zw@E#rUv1QR0}MhE-3wZ8UukSta(;21_Mk$VP2sBcoW8%XoSs@L_k8&*{dsqFo?|$- z$aF=tUGKZb^mJD4v2xG+ec86Pn-W^Rv;I)++5Tp_t>rSz$cu<-S9VUtrLMBJ}XJO}i6lK=R%Uw%|<&A9qD zYl%R*Es3uf=;x|$6?gOeI4ne|ebrho$1&E5O|4b;7fR-R`A&}YGlXmWI!0@y*$+E5 z?GA1?0DMv1ozg}fb&%`V63$POgkkdhFt6K`-5XfKe5gqKGtpkf36AqPqC<|{R73+I zbay9~4tZ90BC6JY7l&>Za;AM*zYVqcSgC)%&H#{AGSO60>P}WxCXPP5cOFpMw|r01 z6u)XHeHU8pq3!i~*(_olpBhXKa&~*fzd#_y0pVKS0ebyo72HuMdGk|wItCiu~WX&o`j@w<0M2(65T>fkij=G%o+m0kXo;2 zTJeOY#Ie25uoSPGk3_J4V#O8EiLHeI*H8;o+)hXNJPAm#@1M3PKf!ivN9CJLb-HGz zPNNc#h^YAL)F}hMJ`aDz8zZ7Y&Bq5b_n&DA297^opsJJ`rs++qC9v_QMM}~kDk_pW zfoJZb?9+S1#EYnn;+vxsTcC)U?QNTs7G#kaf+|0Ul?|SiDU}_L4iEi`D1pubRLHrc z%lwIr1Y_sJ%NAM)1_eJi6#?cMHLUWCcM+%1@$#qcUjv+&% za8H0EScc?Ys2auO=Bl3eJyy&B$l1T8Z!&eX5Kt&;N+UVX;@-juB<@vJWx0qTX~p)E ze-sSJ9k0qetf(kbG4+SruJsX`a*C)i*&zHD1=kmzzN#x@31?Q18jB-i3-X7`*+^KV ztu-HQf@0u1sS7q|;zZjc3gv;&Aci9+x^%;lwuEpN6>ijWfkF+23cN)EWJsdGup$*` zN|TIE3#ZkiP2?RIk>#Haz}_1>BI)-cBtnJn5;^g8?wrgLz~V+1r6c9Y8pZEUZ&6tc zEfm9Y2J_J=7L%z-Xc9n8^n=GZsq@*+JIGQE#6l$~g$_=OR?#0N1eq(&eF&ZEplgLvAKrEyOp_Q1Zd64Cvp+X}{<{;;_`%l5jUV)|>1smjwvVcSo0vH#gVs+-7>RPiwuLGL?07}e55Q+2rgEf z%pVcmJ%BMb7%Z<&9_P=SY%w*z)nSMrX~3IQSD$V|1{Ei0sq4oBtREmfjLJjZj~s?#aI##G$Bn+KC~waiHR~BUwJSuD;kYm8(8?MnYy1fVrPi^?%;V zG)!vZoiIcNCnOLNsBV-0xu3iD1z~X$A9@n?rf5flUjJrB;?4CTjEds<4m?YmI9W!;4QdGO(N^oKN2U!@5GD|*_Y}hx4B&3Kn zVv%dmo=M*(l@`Ra(B$?^j+DggzzXyC5gFBTgjrOCdQ}`lQ6`!${jDU5>pfHdCb9(T zPAYod8ih;eE%7DB=N7t9jnlPUy-;dEO~+q`B?Q~~uIx;}l`o`e)dEw3Ff*miNutsK zuKvi|Z*U=n-n^mn$Ust)iOcM7C$ibqS=I_$=Lv1_&thC5ErkisS#|bwCreW|AH_8- zkW?qhl5GUY2|idKXXj6UxVOw=YgqJR^Y(h~5afTu;&Ho8j%|H3Onk3-GKwI80fVFQ zd?kPyVHt{KVa);=eyN}PxE2C|uRah1Kzh3}%w>v5PQ=N_1I=>cpd2ICOU;)Pz@i8*L>#zl0`q( zIDP5;9M={kTiX>-LL}wg;g_*4``ZJofvRL`x^*|T_|;_&$;$CH}*Rw#lsY9GVvmP`V^R6?UZ(R&F zoeDz@gilt~3kWk{g@WqE9cTNXr=h9Wf~xEp<;DKM$*x0EP@b|_ydpvfP{Jn1c5Qem zEEeJ>WHPpVPItL;ujPrNPTFiOLNN&bGIWa<1^aJA2Yy$p9@f2f^cg*Xt^6*ifmZ;F zZmC&<`0JXii}4hTf%iUi8vLLS>>yY?>M|+6P~4sI2*;dP)(TZ>Mmf1V>0h)SnN-|O z#=7el&?HYSwqc=j2vHX0QoB2tvCOkAf+#S8<b8IpiB?>k;6ZlaB8(xqC)#c^K9rdw_E%zO9du67eb z8pwi72Wl)PzVc`PWn0fv+{!Z3Z@79rbb8@EojWgt@4@{aDwu5mTK-h)-CS{uNsLsz zyI5(==zGS8an`xr_2;{C3+cX9|FeRWz^|CDS28DChUKSev{}*|VltNiKe4lI7!Td~}~d{lJ2*8|xTY zY~3i)VXxM|`0G3X&2NIn0w!*Jx%|Gz{I@1gTDm02u&e1c(QLd7G@Dv;CENs6Jfpc= zAxzkO>A049yxM@#;QEfevSYfTUeWfs@}X1vvTvlG=EK$sE3O;yyZr$ef#^V{ejXUE z-og1?9o;YVT=Nj)IM^6q`|Hm)274>cjS0G=s{WIpI_n%QGW8aJ=*W24DP51RE_MSk zV~m7V@kQI{QH)bCeN~tfa z|Ln0{oXm`D|L4fw*cyg|i90Pp1{oEUm76P#xe=KffISwwIs7DGFxTP$#6Dz<&I!$} z>6Q%cP=MtOMTF}BueGIzl7Q7i1otv4n=x-zCQ9Tloj7U9ux3J6}z*%?ELB{9+)i?zf zjhYb|00r>^M=G5bZ{GrR5uFE>N)1TlO@k;H?5|Nd#^_4w zAztJV@n2A2Mg1h09bIw*nlzygC(mw#l3KGafF|k@?H9f(0-deZ`Mb$Ah-Qe5rfcxZ zaJE{|8%;m~FWj&wPBwQmdt6v-PgmLS{A*JZ;jRe@VyxeK>{Qnor2_%HGi~DTD(=BD zE~I98ySYACxx05lXo%b%t*9YpLJ9H~30JON((c@v3aPOpTB{^ydMKx@tY!bHq1^!) zz~k24r3RNZefusYO!WlLz705i4+0SZgC_my`5PlPW{^Uk!F9s@=1Y9*{Qb_L_zyuf zoxtmudSUg&$Oap9e2*iJ3qK*S`TKxBDGD~TXSv}!&4UTr5PhJAm4kg#!&L(134$1l zrXFt&Y61%2{XuP}ugC z_im1~1wjev!{P3m*gPaJplkBL7Oz5CH2j%y1pOxZtn{1n=6&G!@EgASN>Bz*z$H-4 zaERD|3Oc38x2adZJOtu5FOMMCOEa+Ug=7xPfg=!-=OZ@HQKW)|+SD@C#`WS86Y(99 z(0oCfJ!{<~tjeGfF`7dTQb>tFfbD!=6KF&O6C~u>%-f1o9S}#kGc?}8TA(z_<$=E? zfj{U~PK+9bR(b%ZPTfBhDLpd`P^SkK?1J)_$tACp?^_+zYWlo{#k)@23=iEXVfxoM zOYT@dNmOUhWCNTM$Vv7cb;npJ6RJ}S*OA&`A417gS_9MA{n?&;ymb2Cg#d3>zFH$7 zImfwf_)+T3B-Xt_rBbPfU)aXwb33Xk9$R!L$2aluSmGn_2F9|>BPFDQaT6htOv6YJ65qhln z-HJ8FuJ-+Bh&!Yp%)6i8r8{u!;&_qd>0~HLqi)_QWJXyvpu<}c0GM!+fgnSFnZ52EFmf%5CXi(END*TAm6~pTW9aJ2tYOo6m#tsDy>OQbqi0aBXDBtkwwU#oe z-TIxqV4NjlSo)6fF8sH?tb0|E61SV~;S7gwsD8-}y(=6i>uk;{XeXYfL`?Lu>B7z! zWQAN@hI&M#xy194fSJTibE0T8u+qadsnYL4raQF+C7TkGh%7|qdNDT3;xiy)_fD2M z*rAvrlv_-1``^5B0QiDI%7Ozy7qJ_>b<2ix zBH216?t|HV^9rIvKid{JrD`U-MvY3&HhWtps;$D+m``jH$A9VMG@nz=PH0qI_bTME z4;zuFFg9~3EK_dZBtbFpkbe7*z5R|K8h2J+9biHOtw1>8Hr5 zg2QxPV1rm*1GHb1=?lMB^#JZQj#bbI|DJ=4U#hOOy`72fy!p!8Q1x?lB%Xj`kyx}& z!(Al55YSk*FbHjublgY)x|?InCLT*lM8KJvz9eL}1i7E(wx>j?TF{wc+Ike08a6?eSenU{$Q)SY$2~inYBTp z9-o73H|3cX^*UU+cxn;6XBPA4kEs*n**&lHKPKn=<|qcSnf3Rl39d1A7&Y zc<15u&TJe*cv+qDm1c+jMq=!1Ls;g@NwTL+b`KE07t2jX zYv@c#;}i?8v+Xi9x|{bte{u}G91^o^Ou42N0O(?0PssDn*e=oX-d;2z&NxHqif^h-X!rm$YU=BYmJM=)7UIeqojf*-4?iS z1Bg4P5k0+w7TMw3mtd`$D0&WVDd;{aBi;P|nZyJ4^b=Xz7jQ>#gbpMEOE&8842SRu z^=N}kp&^zBauqT`@U4v#p>A+R`kXcdBXL%@>Kz+tTfREH_-h|OUM5VVwvQS-HI^70vRX=E9-xVtfjjRSO^xFEiIuJ8MOsv2$&HJnEk(j+8FQw>_3~NZWWmlk(v4b zxF8(N9BINP|2B(rcIezFzC8weBN>=26}k)?w84YDEWGp8Xuz~r4Ew~WB;g!~1&1sX zG9P!&3MEO>AcxN)oKUqlF&nw+xPLY4(Masy-QwG?kRyWRzUp_)5v$ ztd$hhWnj;%>}1Y>N(drL^6-Dq)8bVj84Sn&(DHB}>T(Z@Fa(l&La)V`@Exvm{S!k+ zJhf{N)3F&j$os7|-S-N>vvYz<@G8mp^i^w%Kb7H^vv+oLi@d0bhxTO#(Ar>m`o-Ui z*^Yj{!sh_+`Z%SEH2hQpMcqz49ENCMd)vqnZ2Hgu&!u&H~G^2nW`}IG5FB%AnP9e6qw3Bg{Nq4 zIL-Jq4t%pTMMp^L7q5u4LXh5n=79WV5%|q^!wdml{pI*V?Wv89XZg4sW9%XNKoe>r zH4!_8aN7|G1UI^*Y*LA*R5*`l`|f|2u^Xq*t<$JvG*0!(jd5pu3edX~6xqhXZBKAn zb1zpRXMU{~T|#?L6Z}#~V{NNXgC?V-;Yh$5F+%qcHHqsjJ5(9@3Z#)8>A-IlLv@*P zlwks7*M_}VGhFUWdIVR$LdUdFx zA~fQho46AhA$8fw)s)RyW6G+fbgyja(n_FFa`mj4O){9paqC#73Rd7ZCx4=FI9#jc z0-PB8ICL5NzoJR+n0LBCXSAafIxgvz7gH=FFAZV~g_Zu2b&^MMRpU4xa%}CN5`O_W zR$WW{FtO>_v}U)cWY_ZOoK!|;HUs*o>Z%h?=os0Ahjix5Fyp9wRAV|jRP*^k>uj@ z({#J&f2Vp?(ndfSci~`Bo*^K0yh8+LZsq1vM^w<=&=RDpcQtw!S$=sUq;~VAf*6aq zN;@R_tISP1fVOwyD$yExD`B+$#=@c}sF(>Li9%JB30f4EszKVJ_Gvo9?Cb@AnZ6Z9 z7lN|Y{%Dhs>JYG-LF^WC0xkty@0Eg5wx|y z@jkd}5YhD5p2`G5# z+6ZP5;u}PlHQZJ7;P(h{e_DMoN28FnRAq~BbMcKd$cgC2;)VbMT3BYJ=+O4eHj0}K znr+`blggILrc{5c>J$T(OWgj{$Uih$bqh?bl)SyO8RQ;cEcp2TsZo4*`cIPa#6;k( zzANiysb2=d{z%grW1impuMt}P)USr4LU2hr>NP_oFt>UT!c&8WuVJf@+UdQ9)+=m@ zNNIOSwVAfb#3>x*Y|=`($xaZ=mq}Vp!-ubWE#i%n$AY#7fE^OnA;Ho@P zCQs!u5gdGhG1a&+^L{O21Gp$c>=~heECsl_RM(7%5sls;2UIw}=;;w2oupNH3lMDq zStTTRP7it-fXh`SSm3P&~8#so}JzsPqEzN7y-F<_(7kc4RcBc<(kyhiDc3rM*IBnKcjuW*>pSj4j zWUq0$r+WmX%>^^ph0W_JzNI5(EINij?Xq5>A?nGj_b#gS>_=extIBi%O(K(7!6~f8 znn|o%fXXzd_&W7yjBOtAQn?`n7m;Q$`)o!R_GNc+X9sXJb7j?IkXG@JCdDd+n4 zRx2;UVRKsG9@&@evL+>HDAP6m#0O=zdu6YB2J4$w%Bv{s^(mwY=v)P2B%+2Ovi@7U z44<0V;JyYS*3F{*d|8&@Tp67~g({1gv&;A~pj56(!8S)bbDgD0pvl#Gqd+UKUmL+b zgPGS>SmaY~0HxfDt$8fGIP(a$7SY)!T>;JFP$DPUSdQ#POGh z>$N_bd-+?`@!uGCTn{=5q13(mjvMesiQS>rVl{l(!R$AYcni(OIvmXh_loZ)=1LF) z0ERhu5Yc$TuVI|5nej>D!JaU1-?2Xv@c3mW_$M&H7u*b-KytD;8f<(8TL&eQ2OD80 z13S52{Q$wvt*dQ=Pb(}1#GNj005T)OjG^*==9T@x#ns&HvCqd|S5DVA*3R{I_IGQR zh|yaLCS86B*)o(i{oOoSt6#3;i=ps0p!5+pd^c0sL73LEDFor~mwtP4-8-0uRL&qB zqfNfhK<04j*H0IXXiK_lj!rkXU9Qge^2RA z0pA2X;o!<6U)`6xnTw0x^Tn@)KWTd+kpuraqsN#yc9u6zq6?N5J}<@d<|?a`tb`3I zDHzoJz-+1CKvZ}YoE>CIUZwj&5BNY$@D%)JLjCTJK}vYg8k(b55YQdlT+)M|^K&Ce zS>tYxi5AKF+zDaadFQWr^xOY7Sts}8)-HDA0NdE)W=SV9x)6T?zy) z&i|Ws(}XZVXaGyvw)VK3DBslv!n@sUg#F}UjG_cS++=5M8hP$eiFmUdP=QUIj*H{k zxsBE+d4k_LT63}J)X&=6V68yR?q$U8Tv=%rq0xQRg*Hmt6Iv1LAQ+&Y?Q50KgykCU0N<)Ys|eQM5F){*wAFUCRlRNEEqU2l>D!V ztjPhI2nZ&9mD>5F{OnnvXNd8bC1bCY`m`G)Gz=08OIL~l=t9n~~-&P_xy~UH-?OxQ6@GobuEC z8*7xgHmwf7Z{;QFXXdYws{&O?$#R}hO#lc-L+%R}$fM5_%AG6~W4uDJdJ1Mba`&R{b_LAZ{;(3a2m`@68*RaJo`LKw$mFSB{oh9>9#dZ%gha(?o!;+f<`j{`M6jUJz)-`8FyB~616Q)TrY_9 zD#qct74ryI?Q6E%2EF;bW9i*Aq_4p(KRXstOs?>DKce=^K|+Do!}cZ-19R7Qc6oS1 zGXN%bR3=he7cn3G3~L##MK;6L3DDxW-z2}Hg?ttJDBUrH1xgXw_#1rXED~LFRwfxo z?4k+-(zA8Q274^^%|>gIl5~wFSCl?jxNN$Hrba4XfXeh692Y{zQ6X= z1jZPJK!5uA9ZTNJ_pf@Fx>}rg`~7q4O5nNpQ|^i2_|MI@>(FL&HJ7@7huq1OOZQ{M}oQ* z8N-S>;SNjIiR}AWZ?WMhkc5;8NMkn_0%PVNVwuxpZYTq#l1%fUcDMbItM$U_I&CLj zOsL|SKm@VarN3c_0J7nND1Zc_Z3seUOFnfh@6gFLQ8ZtCa_ceuy&L~)NQeEN(XlI| zfL$ffZd-g70n;$F!fB}pdIz=hr(*;oVCB6|{mP3r2`sLfk_rMLV!Fy1qiI(`<97W> zTaAfh+n_M32M5+7FWyW}#GU4ehjyK(z5~W^62xYH_vQgUz>919K0k14Q*ut|>~QB= z0C6J&umg@@GzQj8h*8mKZw!7jTbRFzzi-%V;vLV3Q6q=h?QXY(`42grn_;xkK<)?@ zwIO^2v(42BGesI!qGSy5wuo|(AvLyad?a2i3!X7td^7f8zD3l+@c{FssaVS;)EkP^ zsbQmJ5k(p@fN>WBigxjzhK52279>STIb zbgPAEDQ)R1Ne!?3+KsZ$a00TtW6?DPllsC=o2H8PDpZ33Ha_yYxa$(}Z%pBGCsH_2 zGjMQI@;Y^&b?upd?Ci>|{6GV&w9d0eCzo)LQx;P)08@~}x=tZ%x7s7YD=frPm7EW? ze~VzhQADfIVF9}oq8>=^R37F}t!#Xf zLhOfe{nK^kJ1)p)@_>Sfe(zy&1BNDECy^3y@#b75+4>qVdYt3AwNtA_4a{tCnk4xz>Aob9PO6l;=hlwU~Xo*;i)w>+6fz*SGza)0T}zgOdY)wVEF=fS|p_kF)F^ z5JsWqbh}+BrZHO(_4jDLc;3!MD0Y+6R`_qG%C6-p3(>B}5hx!WAA;j7!*dIn4D)Am z!vM1)bAsm>eQdw1P$etFAlJ%=G(lq zPNcfwAKqIQlE>6eR^d8)4!K2jC-vK9K-w)TK(!6Z7}c{C%7p|oT4i1<9=|@259-ou zs_=r)qQ`5<|-ePZwlM5|`Bp1l7Jc#b%g9{>5o*jhv;&G3zFAXE<5aovzE6@Hr|< z@?5n3tsr%9cx^cA1VE+En*LIC6vsqe-ItyoC?uUJyg~He+zvwmwCA_wR zqV0*Dkq!1N+x|VVgbHDZAjdY=N*`nc3i!Xqd5fk6h!^y~;D7iOiHn=<|ERHSOdS7XsnY=d@o5|KKR)e? zyTXh-?2HGC2J*D3hI~YjFh;Wt^qF15m8>FZOZ1WV|9tf}?@GKnv}=-AcMJk6;%GP& zot|W6Jv2AM)WvX2fUau)b?NSwRY|X~n4^(K>i6409A*8~x{0F=YmDd6c${x+9E+MI z$50CSqBKeymS=591PdS^6{W^Z_Wc*@UpWN>Ib4pjON6KdWgD4)3Ts=D8U;6NZNgZ% zEW3^*{*b?;lUwpC&k!eQ4{v!Owl+?a_@L`EWBM^3iplt~If`B#adc415@H~El9GhE{Czg`%7Aj!VH{Y< zlEkV31YV%Lc-0L}o7i;}*3|MLm+|w)P$ueV%9JbU;ff(1f5Jr9+FHYYB}WAcQjh-C z!(}qCbt;i!Zh%cab@ytwa0t1WP^guW!bgqUn-I)Fzt1z6leMCaOGA|#fEErk%9Y*J zJ5evD88UeJvH;B`uM6aNIrPMcv2|c7>~=*m6aH}x7;j~*Isyl@zPUerZBqGMju3}N zCP!~UeoEk&F%-8Vj2lg;sX9iB7 z-o6-+{mte3&eJSNv4A=Cw%k=cM2Quna!1}<#pc1vm9i^NGf2>pgv#lARxDUKt#0=| z`E};g1bB6A{&r#Bv9XwVI378w0l38x$ltp2aVd9YFj4ivR$`_?YqlXy+jzEFN6tDu%~7nG?e41oG143f9@eyP`x9TNx9j3Ok@yMc`5 z3jIX%XTkkpu8t{rad-v+cAy&B`n{HICF+<<)3C=TYsD(UIWX=_m~LbaCFsp~ZzDTE zOCxcBw}HEVTI}xcJUzy0gHw%cb`8_(%*u`A2#Cfr&aN!YHVMnXpSGPej;Z~tg~C1H z4*+rJH3>+-r%26Ir+2-!el#NJF>?IGkjsDBj~8 z#+zBgCwfrj^1%S~C4ExVUsc3bhE#nRD1ck235sO9uLhjXNX%u&FXPzAPag;%A<>qY>ANg1NfEKk<$Q?2wZGDn+cgpCqo|>b2}o4#LLM zK~bhROjq%uq#=bo*#$5TdVDhBHlC#tiNPm!G9T{tuzvCzHwS=!$P0)aa;8Q~OaN3A z1(sL3IC!dUD}^%_7q$%w!(tTYH3;!h6lx&$isTcKoh8oN$PTsa2pVjYM z6tJbNEV&u|ED5#~R?HGb!j4xc0L8*d#ZhziJNNd{B&Ughq%A^YYSdp0v$|*>^qRURFPD`(5CR5%UY+m5KtSx;e zr&6HR?ZKu%*H%)&;&uxU>hp}$eEh|=d`lgRbC-%9=KjE%dNnK7mTa&=P3B1)mL1+US z;$=?#r3M~3RQ4XQDH*FvaHU6ac(U{#WaurZWW%& zCS>F&#)KZB;e8oxOFb%F2{4wVs2ckbCfPC>-My|aTo$8;Ygb-4+QlZR!BC%oCHM|Gqu3MgA+vk)#7aWZu$ z8zm}>sj6+b{ithvn{mahjw>d>8yE^3l5MV_wEO9xYQnOy@mAA~ArQjD*S zL|ok7e)|Q7W2`ZE17kMgZ<7Olu&PX?Bdxvg0)Gr`NYWNrYBj<)8^7K}dLJd?D7F7| zb_ElA|8V{|wt!s71JGiZVi-uxZ+iBxU5`oCOM??>(&k`1**Lao%BIi3?VlNdC^0fR zsMeKS!vTpdMMy-Swei1t84nZy->ipPukbAy-M;5?O%7$+Ir6zrtLKx|PfyINE7 z((%hTZu^KHxdQPS8%Ra1^#Dl&@O1WN zBVb+?ayTVmXXwF@D3I3JmF<8MpYMbRVYStX4@lCa1C)GGIO=>H_Jz+Q69tr#Mq404 zv!#*%;Dgvcn0BHG#x6ldy2n>TSQKhk{}AvcD>qx_zSKo4DJJW7^QXrQKt!O*C>2BT1q7}0d<)>PN*pQ@X!1QBma$6p#s5eNv^KkRDT zu@;51QOrtFC*IehomFo#h}S#i+%svZ8;l1491{Xd)i@ky&+-=mOJZSz8ltCt|6dQz(?`rvxXrw9{J++Q!Iu`EK+@jm^fu{;p1 zhzrb)0zu%)?_b}b#r^=pZ8rE&TzmbtN(2wp4GmfMcFLPUdpC0{L5k?~wGxoxFue9~ zum;0dbT`?w4~@JK{=c{m>VIn;xzd0ufzex1yg>9JL74wnqJ#^vT=f za-(!zXxz4XYeqixG4?{mb6x!VsvspU2d;6rEwiSDG$pfBj>OI52?cAk=_TvUDh@{H zz@Rj@$|<5umnt-hWdA`Q^_-PUlZX?!g=ByA;=b6eZhchp97b9}lM-y?PEZAN0lB0Y z4^0ZbL806$0LZ?~GQ_{8k`_j(nuI||5Itz6Hx^W)D4v)M$IN9E z&CrMmxY$?->Xpw#$=pYuCYd{`;yH;0u4>GYjn;_XuP&$1BvTQ7OnR2B981IyX?xXX zEwogDO_<0rF;7#P*s?zl8H8stJ=U~OsP(eZ0N{##3$BGy9kXFg=n9Hv z9OxXp4$fNYVh~tjvi$^CWfYzYYT;fIq+|Vh*Yw?mwM`2597xy>fF7ADL$gJ?MtQS@ z(zJQNn@{YsP+?)=+-p;Z5F%7Jr`=}_;0Ka{R-o7L?>=}wQ%7677q8cyafK7I{Q~(I z!8V^%%2;NL-Rbw&!hTr8km(#Ae$32H7RsNAh{C%&SxLrQdo}?p3s`rT!(qx*)R02= zuN*^RlFxd8f7I+ItDjd9%{qiB%Zdgu9IwP$DH{Jk*(At>i(D{)}5x;2ThvYKU`8#iqK=i=GiZ%x-- zYOd?u;=zu`bIH#MlcQA&hRrj|h{D+iHgjL)=E!EbpdtzZ05gRV)NiJfW()5t>pS5~ z>s#U5p_{==;r*M5>)-0%}ST(kbxVZNP#u^s!v{O#!DBfJ$Pe~eNgl;SfE zMTer8PKo+qQ#UXd2G^9fwVd5{hj`_Av5Ny}>wY`J*-_ZY&`^BW&{^(U1wni8Z_>3;!Oem?EIy3!{ZGG}_GH!|ZIC6j9TOp!2sg5x61bCI&3 z+{8fOSzKIrSN6D3I3~V=oAI%B1uA1CD+b^flnkmuMmbjHK;+Ba=LQi4MC<6q(f!Y1}SU zqrrr!zqNd5&~xJtH5k;8(#Z@ilv8)lwF5;H$B;dd@V8}ypZrKBvGAzar7*d7C~J!( zU4=tXnhAAHm2&^|Ukhlo!-S8ToxI8%n&Bd^&Qrc-P}U9zw_{%i7xn!1VREvU{x~}{ z&K9u&%m##6jZiGS_EY9ap`9m|R-%HFUMiBoxJtWJ-fK43*=yW5@1%BDeUL%$+XRYy z6c{+LvVt(&3nw{N>C3i*E7<&DbaL1fGdrj{?wA^?|;l>pX&*92$4O4l$v;`17T_f_`k=&_`s;8rYJzWvY(3>xZ^(1!HO#P zwVk;c#k=y4uTYY4^7ddQZgM<&^-83iRYBnw(U#)4J^da7CypZVX(1>TK$**{3u&RO ztZHAbxol2iRbseqP9jmNJ?*C1dzx%Y$mN({?M_0U=rSE*qtaUP9vfH4ZzmI*ATzZ9 zDD5Oi2NuE~Vh*TaA`@4Z4u}XPgO~{asTWYf0a5yjOIo`;e%UF(3*-Y$Jlf~>gVqFZ zM|pUuwl8lPU}1lZH?~NWit-3$w4hgM0;N@n-t2qzOYH{ zovQrc6@At<2+j6Qy8H|x_V_VixjR|JSDM-I+Xx`goU3+`bJJTm)!)GQ-dRN_JgnvTn8e1+;rDj9UI~I`BbB@{ot^r4YqOS$riU zj!R`r@N+%`3Uc#cqQK|VHxz_NiR?l+_4!_UO*Wt^pg3sEI( z2h@2o6xpOdfl-$HKB9Afa(k)e_GHXY7f)F7ftjPhC)8O`CiZ!TIRvfB0-rWR2=#1?0cjNCAg+C;I;lbplD2l7L8`r7M zGsQEs5@5qqV*a+jOjd-1v!L1+XF1%*!a!ah-n8bWRhqmgs}A1aT6$bte413IlIzm%KA>2#D=VS?@ACK!t!HUY40(@RUg8%V z4tgEhfvVVI<-Xr@+R~}1BTumuh4+jHttZi?;lBp{I{{Sj;I)s`L978BOGr0?*dFz5 z)JbMzCzRJ7n^Uvl`^TcHZ0^y->)eBOLYU#RMz zU6Fqs>;vYXn2Xjde*gx9@=qs5Z??JzOF{wX;$-`ea}kM+<^O|CtQ@IA>tIyC11-gW zWSQ^d@9n(}kybn;a|wbdkS?8Uf@v_J1h6G24+T8kg2i~HpBu%3zTVyW4US36dV}%j zp-}cI71{W{cu3vpM9pR{y^2Pu2{it?RMm%Plx8}Sg?J8C^r+QjEtIZgSQYOC_$;kj zfoPNBY>CQ$E5vle11gRsT7-e}%3-PY!J?+(G7&K|7*;(DupFR$s?!pSHN#~13vf8$ z5Ab(kT7}$7Fo`I*WguL(^Yfv8xy;|BU`(Aua;Gg%z@V@t0~!+|Yi9vkyGFYv-Bd&B zS~TrxIPXw>8qz-_BBL|Tn@`dZeEd{7G3Uh3I0qM{V#G4DI46nnkzs&NlIPK9%LpPw z3DW2ljl^0wmk})x-q>bm4jK&fZ$_@b2H+(Yb?MM+VMyi8M5r&6i zK+Qvn(HW4zXCx8J(5D)ZVj;<@4sn6EZE~eRXsF(ReWQ{n|CuWPwyjNY+bn${;t z-Lim}uV&@l&;Ci8fH@bq^(lGr$pH`0nXWhxh9RVJ_-eX2pKC6fgBJj+Lzp z68wxg{*t&R(}OOsR>1cxm-mw5{qCv7>-vmp$C2G(o{!(*4(2naZEmo`ZFsnvXYeae z#+qDWP#0iY*QNMv{tBW#!nC0kG?^ODz(=G>qDg-HJ}-U(aqkE8g8f`yKO$#irRukg zlJUWn+n<+uZ5PK3CDmR`@5}Ay7J6@w{piT#b|vB)#@ji-$ybcGn6vxBixua_7L6QP z^=Ohcd0={1x~#9Bw=;tcWeCO66WoSOiu;mkO5^&dcb8vz>ft0}q{I752FKEDwZ7ob zOMI6p2EE7gkE!}+f!MZOtZ|Mx(^KY-laKlLRX$(I^C7_;L+5a&dyQw@MDtQPjOt(q z%8C*tLbqAq;eP9B4y_(7Uh!+FWVicgX!H2sV5ofe)Qc}W@O8k}m$e-q0)4@65+CEsZ?Kv?0PD`m}(J3Ct*83sYQ6y`fq z0@gHF=r(wYh{@3WjZMk)q6=bfm6foT+Wx+|nD*SbCCQNAzj8Nk&?dWb0tkluBR zySrC;0j4(QgST#25V(g&1&Aqd4e499z_ZPThd_wF9Uh)W*j21*9 z{7^-$5##|)Zx-F;C!eOTR+oO~vq^`u;N+nnq(7-fg!?#;BCWfSZ`Bk2LLX&TdpIdx zJOPnF9cv8jVSpZO#rR5(4_aye4^;F(n4gqD-BR}oNHTOnYPIkFkEe~*&d0K6^+yZ^ z5;Vx-{Uf@{Q%K!sH6utXXGK9NDatSWzTxUu@aMw}?ycTpjF~fyp6+wlX(3R>`Tjru z%BB54390%)koF_tr3YDr6;+V76bM}qpXRggxFyPx7Sij*_`1l7S13;Y$=DPw=2KS% z{1t7(nU@RAf=D!q*2aoxTEV&7pB92bE8WV92n#0q?mEZnS=gqY(m}&nmu&y*%Eb#- zUr@u2JgJ-{K#dS)jCK&WkM=y2sJBezF-fdtLTKokTqe}UE_xfoJ>i+Dz(Xu;6<#EW ziuH`EB~8Jim=}ptsg2pITZty#eeb*z7^H{^G5YD|MPU;7L9Gz6&aW`k1{?4Vyn${} z);KJmcR+!_h!UA8DHMCm!y+l4$wDshkoEufCdHn@{~Ny37bn?E@LrTtnC5~DS^ z8|M6j_a%m~XpfphrG{IWTvkm@Jw7?%0U2(flOT{Vqa#}kK@b%!;4zx>!r(hS=W03) zsVjzNv>0og)E^jZdwn%hP3H-niI*~9N6TOJ`cdiv1b)1%pw?O)JHJE}WNHg@^vPrE z+N=o@r9#dQn1wE6kgQy0{$%NpAFAtY^ZiLMgSBid@YdR_4VN;CtJ_*Zc*pu)~Sop`=T#<~|qo)!V{=+zQP zRDU?%sCD5p)|FkYvPbh2rA~YYC(UmpM81m;MBqjc8}*7A%}|BLHvyHxU}-RU#72V? z7hYH_Cgg%e<%4UXZ~)k)7m)zVnLC2_#im&FWJ%!w+pCe@YXOB}Gju;-ZzRmL#l?nh+Rn8~_-P^g{t4 ztaL<4Ag_T2v}NDs^yz%t+3F>~mJ9c;SbfY8p`^6tDH5>rX3EMg6~5 zc|Qq0!STb4!qCar65;@+E7xc(qy)G(`q}MZ4oxQc?0OZI1rewJ;+`0kX1auw$8d*- zQ!{IY9l6`}Zu5SzbroccPz8-dHXzkn$a;Xf-Q8%&#Y2+&5n|X`;l4&mq;)B6sg@fV zlWE4rqoZm8nd;M;tdJEj5HF#;W+Oe6v$VkPg;ln6FR#DaH#q_%zHu+Fb#RlS{5rE; zF%z{B+z4k%-Nsn(YJ*xQ%H)P3bx;pCE}#hm3ue7BEFTI{po&X9HY|VQ`X9NSYu~+ z0-nuQ&m`KlE?FlimBlPDuUVhmc7IcvUX}+YhwMF%cU~jbEIt8{%Q$|G$z>DF96KBnh}A%$LXStLlp+m4_Bw;~xi?ObgBn#>|>JM+@%!@BZsar?1dU z=hr@{?1YSjO8*BiGBGi8gx=7Be+|UfKz*Fb*_%-6tv4cynje+|OdAU5C7A(=XU zF?L^X$(S0JhhzoH*?gCWBnth%6E-rXNJOw;Y|N=&23EA@fLf$bsB^8L%h3Vp5Oq9y8Z{)taAc*7o_2vE5%15D$PwoSj{RJ*ZeZrkC<3%rd z2x08;i6qe=B}D`nOz~%&^$bd4P@8xYauCAY5}ojXDy}+gK4JI#It|m@Iu6hnHno=w z;NK_YtGCo9EI?mCkYcK}R4Xvdg`lA{;&h+6OxP)nBt1f;poEAJ3a1RN#fgPj;0%q@ zWPwSRp3aOMQ>}$0Mg^Kc9tDmur)q4LSYTBK zA`p2FGa~cL07C)67MupPgY}D^^GI~D;(ef04j`pW;5*KNfWo-PkLr~xf!p5o`_1TZ zSP*zEYk-|mbIWBgN^trIApNIO)C%`W60-!&2+PT`BxI|vtx6>;c(DT3jNwY}S46K| zIquans_qa1lOGW7WD6-M2c)kqvb0$lT|tu~aE#2*s{fOWsA z=kj(Ec4f}Ws=~LyaR>1UwXow{$LQr%%q_|Z69!fFM+8Vq^AZW&D{@A_n5^)!}2 zj~oQO#kZ}{L%0#hjeQSR8jYbL&k=Dg_oB!s{z0sh%#$H2{`)l8!??WAJhYg*T7d4) z;BL&Po8I2wRS|)Td~K9xUE1mM6t}NJXZg|Gfwjt1_dw7?J8*u_%$@PwWV6(=+=lvt zjvRNA5f>QM^{qo7U54miAFnH~ApexJo%5IMh#}#3Rpo-A zLZ@DrcEc1y=4hyp3uAWlsb)pDm-c(7ry`$^$ax^WN6>_@dmWgV5fyunv^}adD%&^B zL$I#*#ogbs_uihoZ1yGMw+HQ9P#kmNh$(%>8y~jBtUVh#2xRdcm&fsDy-8>Kdu z2ZNZTF@Hy)TEq!!N5tbJC-{95l|m(lDQgf1XI)^rzk(c@`jVH!62XTh1b>ldvN4Hycu*7 zPfjLEWYNjF9!QSdu+uc1@xu0uc*gKNkZybqo;S)BkESCs&=0Nd^9jE*+lH?iA_C{Ei_ z_wLDgu^O1bf{3lS6>!e2l<(E@-{Zc44SqReL3pGZh*+R2_#zsq-Jc}j1oCY4qbtWypb5Z=u$7lPs)XIDnpO!!FD~_Onf#~?boOx$^ z6D{`Ig!Ul_x)1@Pi>-Mv;CIncvqq$xN-;2pxcP0%QCjBoR~)C0@glKEAqGV9&?=YY9#;@=6j1cJ&AX=>R_z8VTZ@WeUU#L>A|)y4em zkCDzcX)V24269SxjE`S{eDHEY=;USKHu&mB@<<{YmpVu?-ntE*rU!#9F@Z-9Ycl`#b*a zP8YrQlM&dWQxY*8fi=&I*bGtpgF3_^sudJBhztdL?k-wR97uEEZZ<}ijKrJ}y&@XC z!d#3{VgMlg7?rgwb9QRFP4L5wCPtLeawVQ5UcP2o>WJ8)!oV#XzJ#wvTAcW@@@zHU ze)4$si->OueWbgCvtuc0A6pLW3+irmL9{gu*-u!yqV@}-soBEx?HE>_!eI1JfB)_D z@iFE0sS1DGz%U8CduZJc^&j814UnG9^p}Qn1lMtl#cCanT;CJBxF&vdkN4^rx#27K zA+q(K7`%^0)|x;2`$A4Z$A0i@{b6vCT98Y_;RCvP{8FY%-RbTCndTx}zpy)9 zztBt2_uPvexD)UiNy9Jd1LWd+h*XXhy|=s9!u?loT#e@=sV zYT)=tQhvH|N;kj@%VC`J^g7&ek!q`5jnu)wo|LSNYC!y4tb7CH;W!EUe>ln1k6sig za3&7s=C44>7DOs2)E70`u!5uv|IecLkB$6xfD{GxUpBJs2XHfpqlg8P)wu1SiWe_ zuil(y+&&cYFZ*A!&^QVv^uJ?ZHrvdiNWz1${YO$pZ~n7^k_!KSRAl#Kln7XGCU(yM zP@stHZ2t$*GBc+78-1AtJ2k%;P!3ezrQh4euU}!7EFup^FwRLb#OZ#>Cin*PeIbXS z#U&L-vQ~-DcOMbyn8jJor37!#O8Zt3N6xpyOq}Y+z9F1TF`2s%%1qjqv?ye~ZzkTe zP`<(=tI9I_MSQ*XGdbwdK}M8u@pwP}8YGr>0TM;G!bbTm#hKHAk?dJia#)jT>l^T= z$fqZ;s4C9Ucu}z~D^WX4$pEn^quEjBLNe~m6WUFjh`(57=Y3bs-C({-^L!>FDS0CB z4<~sHFU(rYa4!QWDxn|2d38(8WCoLMYp940GwHSFQbPB%%UXRYlm#?sP$+6em5U^y zWD&@#ea^u|eI@}wry7*SA2cUjjHdSG*sTcgd(d=DLMe2^hk(*f_00ubP8Rbx3d7kLL0ROqOf>__L!;|R&jY-P&jTW|%E_@OTmQl_VLKF^f@3JfS3(DK zova05s^vkniKvuK0H&Q-VW(h6O0kGi3#Es$4F?KeVK`q z5==(tx{~mEv~B|SDNi-XBj#A%Df!W-Tc6-ZPYdSs~Tl!vj&JlUu zz0=US)7Q@~LvO1npO0~$RAW2P&k3`#SiGiO11nBHLxlQ*`-AOQyoU95%iQ^IyA-rn zPyQU=u5VKUTX|p-p;rppM8zieX~EmGz)})U!mh%Hp4|J5lQ+g!D_${3rI@KON*O`$ z9e;pfirm~ClTo~XR14Meco#(BzpEBR+(6d!D1aKIImJP zqgY04c(J^Lq}YLcI#l-nDh_2^%A{Lx*g~bz{8WWC9Usn>I2vt}Lb97KlS0)epd!ny z3I2(OpZDnkEa?}k-)TPQABQjSK-kHGy)Q)9%a6QD)-e~TM<~|};)bB|)DaEG zFeN(J{(N@v@ZoyEB&9aCsGWk?qT-^qml1i0dTr=XF{k%wlTjaeII;gb^K|sNeW}>P zF6Fj;RIyJCgn~(j9uo>laB;H`C?_r#%}krJj?Xyhn@OmLf-j)gLuWJ3)1%r!c*A~% zL2n_;(P^-SuCtR`U+<~TE~7zQ%6AV#(MIvP%s~_3U9rRtdfb#aOCl?UzI!h`)28#1 zOo(SYI?qs=3bN8IF|&H!Pd90|HPo;xD$c10>HG0m@=0B+68Z@IyODtmlura3=m9tH z+(&t1=TcY^Fj3&Q6r+s@LRcq+Re2*#vfAE`tD~boyCZ5pV6)0Ozt2d?(>pMy;mO{P zCp-${6?=gsi8y+C3NXKXDT=O>eRAGFyTBLei}^#$%TjN#VrnsuwC2z0s;hX8F1L9C z9U;`06CYuMLy4E5`sm>Rr0425D{j#ZKGFT$)FV(IEb&$6ENHKHN@-XG&y^mnfgv`X z$W4r95_r6L=y6^kaw2>u4vv5fMG3E5vQv=I7a8>$yyUD|w}R!@L835WcgSNjV1R~f zo2)3rRB9LCX(-I`Eu4$<{E4xXsX)q$#@#(huT zX#SNba5JQGyHADd6$HRGiVlgCpF=Oe0D*4{ z1qToeC5paU0E;7qCOp;hu}rk?;lHc~3N2XL@E*B7=;Ct?>${5l2`#VfRFaw>0KoWH z`SK5DVBeyc!hth?NvB_%=*`GbfMxhpzkm7IR{$U#<_o3#XSY&ZfDrsYScB30K?b;j zO+}^oBC|jl0SEA4U%fK_N!-5j0K6docX}a02ml3}Dm?o2f?raAt1sB{A731LbA=k9 z=L@zl{g)2&GXeyE!KVKn1ji0Q1Pjj0@m~ys%<+H8xXf%!sYL0Zl)yo)t^cB!uO9yP zP$fJhE>d_B!QC7uNJqiA{hjI`3YF(o@|L}xDlAKt<#6l?J zHs`)OZh((NP-gPZ$-!C5}aO1jA582sig|4;O~&E0rL_)$g#?s!<1ERFn3{tiuTSg}Jm^V?!&$ zJ)X2)Mea~HFbvuosN!jG7FVL<$ektkp>e54$lCiSOOXQ=QUIma0gv}9U~tr`l3>cF z@Odh-GVX*grRW!uFj71IMeIhGG9yo_kI0(QJvlOz=;AKX#Ga7@qDRyMrIxzI7Q~5g zM}gt_7mzLk8q}&X=5t&EbWv*03;M;LBN z3OL5eyA&-z7JWiizwaMcD&-NZCZ*p+0oalYLHZ9SnnXjtrIjZE#&;_7@+95mbg|_w z3oej3ChRqSC5-A!!O0%}RY6;(kj_)||ET-=18D(@%HhHw^g5O=0^Ty_6Ai+$D*Q=Y zM_TJlm9tdf9OI!V`u_x9L>yk>*jc0?*}p$g*x%>*=VT1NJGxjpuuowwv+6w-=Xo=G5sMWGu6{;`bV6poFX7 zyGQKHt$I1|&6z#ZxN+PCPR+v-ZWF~+gmeio59lJ{&RM_SkD>VOL6B8=!HL`5)vmR0 zij}wm{IO?#J1E-@ES+s@-s_G9;^pcqbxwopiLeogYUf$)nCzrWXqfE$L5)bx>V0Tf zJ#54g$n8%5hW*Jf-d;hLll{kB&HAmP+!IA{B%V&9YB$g{`kNH{q9|!fODOG6PEB6Z z)3A@YK^E;GA3Mbx`+}ft!-&%0b@D38Cupn)GOeWOy@I%JKsn4J$xIZ-Z<@rk=vkKx zk>97aNwtNKqcRHoP$k5a=z7Bg1n8x(r!|#?q}X)oFjTmHuL{z^>~Hg2r%_5|^oRE; zSqC$X+(5QOItglkZ*TkV-q{#aTIwqFU|0*{6{cu|?g|5%oC%wCrb<4oFmpdPXl?cW z0Bx|Q4&CZAfo9hZoMi?@5m_WrBw9No34MasDH2_z^LKHAjf96?rmm3y42Y*AO65Bv ze3Ws;AAYQVvtn3Y{<6u%uq22qGxHUcZ!zpYQr`u7B7dVSS}%K~z`8+oh4;8F!Ma&b z-k(k07Zy=78oR>w8x4ay%g1a`X1A!8tx<{CVl8Cq0D{{DQVD{>Ig@D(_l$|MpQRSP zU+T`0J%hr_{t-_%4GSe}>VL@=|*p<6sUEmaJN39-$UGpf)b?aiNZrqc(*Cr8T89{V0%UR_pNGFZoRGb{8%28tz6V8+0RrZET&)j=Q#LqyMC!vb$! zZ22>FKHscZvgx6dXtB`erV4(t-JEFa6Rn!GW^B=CxPcRk{e`dU+9B-`ru69{2^SOR z16lllC(|c;alXIysn;Q%TwRg%x-IaxuV0e{vUo-LO-{dCXU5aVMJbpOVS^;7feFt6 z3@kQt534CE7C)B%n7MVovtLhM_sf)s{MJji%~Txb1fsbg&EwD%34} z9wVDLC|d=?aAJ$t%Hjq9_w{@k&gWGjp!7XI17G0*zi}$vOxdAN{Zi*29N9jAT8pmV z>`z7rkLk7U>1BN9_bM1FZjGZ0Vdt@rmOO(^M7ZML@DZ<`rdxA0+EIF2n7!@exrY9F z8+VL;IpYL2#dFFC<9Q@DJruK8iF#g&7QyxR_t6O3;_Cw7Jip!To;S{&eHUZ|fU+R> z{5mql=W?P>7gkRlXhq??ZK3P2n$8h0$6id(*`5~@7_Vt!A9f#Zb>qPsOUy3;SNkAH ze8VoS>H09sV_0p(D`=I1<`uw52UZD@y|MR^tpPLFxw`fj2rguzAY zrwK}^__BZOR?j)3<$tmH+{DP-Mfam8Zsad*tjAc4Grf1UT?~k1kAhX!JN_bFQ1Gtr z9+ER0js&Us_K=>Tn}dw5yJ#H>Iyj8|r>JZ<=&_e%$!?vR zLHF&>DG~A=kiWviIN)#B%f*=iD#QBep3H?5WBfjQ%>vr8eV|v|GWQ955^A%@;Sx|{ zb$VMQe}}EO`yIH)g=na`3Div+iszw6>9;z!TvocU)gF43eDEb6r6w=ucn8B$4TS*c z|D}`U-2q?liq z1>n9m(3^{U0LO^nEF8@Lh#$&S-ci&qboD<1VyD)c?Kg2$pC$FXy$g|y4VU9_Va9Dr z#kw9SCToGSYD0(y8P0Xpk)Q%p^PSi&W!WZLsRFKqVP=FfGnEaW;x_sc&ycc~ZQ_zM z(d%|mEEbU-xRd9D7Aji*61JeIsr;Lg)Gq6G5uR=&BennngdjLF-3L=Yd+ueTfFiGl{h@ z>KMoVaB1q5#nMp+n1#hgXbi7viv%IG9#i5}v`}PF6krW;1vs6O`=o0zFx!%YWTXzb ztQkde#x_chW7eoUIVN)?>vJO-;FxNvEL4jMgD{vd;pd~J!p!6FdwRC*LJ(!LMxKpL zruEVeBp9jekvnAx`xep=sY=$yh049c-9n<(uYlteJiHqUJ@GgKn@Bt zqR@QydPY(m%$~_IbXp>?VJo#>87?dqZd;5x56Ih;b+sz`B@3m#s}b^EtzZt+3rS`t zn)ZYMB1H#C-w?8G?qAEr;pFPzjewPf}jKGy*hDyO!k| z+-mTA(6_MF<-*a(agI}0;Ct-zZnt>i@6?LsdR1+XjvQ}+=hyvxRckD$duy8%27+gd z(Q%G$iT%J}y=Ve2=*E(X6o&Qv_Ji?X{buh6yEoDA!&lFaJ1geDfo$W^ffUfWw26*4 zkPaZBH}QWK{FG0#{p3=Py5-fe^gDUdZ!FV1YQz;nkY&Q~Yis1YH( zxS$Hp3SPEX%PxXC@tbzE9jMvN=eynh8^`z4gO{~I>w8;Ki7+3#@UpmO9ceC4r>h7F z)V9zWz3Sr6);S|O3F$ZNBADvRmDEg7Picp56I==E*fw#F0Y9rUe6(WER3idrkh89*P!mTTETa|pg2e1UMNo}DH(sHa17c@^CTyArg^*J zVdwhL9P9r!H#N7w@C9PeN(73Jj<86~upp#_an7d&xxGVffg8}PZ$_Qo%^4re#MBtb z>N3`&NTR&j7lFBOXBuOh+_iM5yT&+7D@4+M*W6US9NaOuiVMt4b>D|Y3=&GNYfup4 z1q*pFg?Fr%LyY3DYibgH-vQu90-@#c5y(OSwMlio2@1nP{WHJaA@!4W6re0X(g3xL z#IWzPO`LTm!0%}Ss(5a3f75u-y@jM#`I}m?boQerC(+Zv+u00~Tr# z{DA^C@s!L6+L_EK;p-+;i@%VKsM;e+ZT}V_QU5F-F$Fgh@rnS!&a?Ohqk925NXHaG zn3=UFcmUQN`^-W)CO6g4ul`Vz0F4$u@uyuh=u4Hexefsg^(#JWY@u{AndE8L?HiSv7?k z4$gIa5-6!?iiTK=I5J(@WLPLLTN;{;8&6t9{KH3*QSPH}p0=fBuGn1Ogig11XdO1f zjuc8PaOPsOr2g6SusgllH&+qHl$R2MGX6YDy|SDOEUAZ49x&DMeeAJ*&>NJJnK(&D zyMT!@cmlVy-C`C>_?b7xeU2LA7eN+|-kRKCFHj#gIj%?6GAy=TWcyEsa=%e%Owe|U zSuwcAkJ|Bx(jRmv%Vd~#42&99@YK5odd^#B6*J(w{zVqz4&SNT@{1S=lqSDEY8s{& zd}D&rC~wqDQt_o^MNEath)9cc_>msaa|n+5K$iwk`!{hDagLZGw@D9!A@o;>ZEUIs zSYS~n$VyIZ?&AL070}DSxcKUbi6Oi>9cu}ig<*x?$_u<6gL|rAvcB||_M$R^r($)Tn$pe$D7HZyOL?KdC;#TZ;R$$#iUcRi!M(n}!!5dKj-C(mpYe?%hZ2{DW z$kH@al$bvpFXYa(>B#|+mlA~plcrDwBXfSoPw~lU*g14N>(A6=%IQ6xy|d`49|nmO zhU)re94aRVH5YU3jGeDFYruuy?%_NQNecwkqGJaX3D&iA`^^M6WKbfRIXp!hH&EdT zJ>?XX|4@j`*ewoff;SUuAI9B8MDoEiJI%yD-6{> zL172oc+|8gmqu%$M5LdA-!q&@#65Q%CB6;j?gVB5(kh`Fe#c0hbt>SMM$yxxdJEzN zvN7;A;*>v zOh;J|o0l9QDS0VXh%0xro>$gBMKnoCl-^hiXznjW2L9Qq1`?o!?#@)zs^mr+9Ymx^ z#7oV*-Ru#VDw?^&F+$8sHBGIzWILmolInV_8?!N98R!cTS)WOByT>pWP>On?y|$Qv zPDDv;hkfU1X*%R0d)-GNzyXfe#LAup#xNM*HO-c(FNR0NsdbjPXg$lY#z~)1UhrhK zjcw7tzn*lRNq=&f0LRDq&4_BwB0h)?UEe6-^+M_u9?M1sZM z)0JCXa}l`hKlQzE5tu8@?Fu)|s`HSw)nB4ED$iD#+i~(^iX=5OEaatnxEMq#=R(zz zE!v@UMS7|sw4-0t-7zpYr(7MDrGyab8W@&+eYa1Yybz#lmvjDIyCUCy`Uz^DCybqH znEF2;6@rNsyKss0U?j>;Ay?cDdbyZscxa*gt7Ws1QKfYUW_j>y$4@ zP9RQ9*V@2S(dJ($h1i+bJ^mi6+JB|44DSbY+`I&u-Zm0a=B&S z);S}pUPSn~dA6=t!oJhR3LM~1w9v3y>ZYhr>2`(hzs&teZ!}iCPnT{MTbN~Z>vDda z*H956yu2w)Qp8BvJi@>HyNvEtyE4SBx0My)dOMXV;LqG71&?O#y!|qZ!4@{RT5TBg z`Ed{`OS{COva$d?lHUB{GYh%1K1F{G9lREBD-GH~!Z)-nj=oIKn_G_e2Q`gn#!$B$ z5Z)HDqH;iUBt_XtjBALl_T;?lMV`#M@zQ6+pyA+!g}yf^qN2mDc69d}ZJhl~f3e>< z?Xy&i#^OQG$Wx=S(E_6wowZl$hJ2O%0TtzO*`qG z@BES49_bbRD&QZnK@Zoc7xRrGX2F4CHcTYeeHM1ok^ScDJsD=&<>!0*j9=MJ3iP)-Rxx{Y*z1MhPGHyy0?F$q^5 z$_|g$9JuD1+^xj0W9oFw@WnvTTWYi_YZAuFKa|Y0A|#&*>e;XBoqBb1%WyUcUss0+ z6)WSlG^(<5<#9W9yc};imoL5RIMaRgoG~-JrLJ@WYA=DPEbMBr+SkqVxQ)ElWmeU@ z6TmOhL*s9>yE-5euxS@JIC&`Bc1+ zVJdZ5TC5x#R5Lh%Nn5wD-cPpjNtd5M&3xv(*aD_r2@^#JPQ7#c)n?YAONVO>xCz8+ z9ZNHT_{}UjcFzcjPU>s{r45@na7Rr1$)|1*oeA-HT{h|lNxj4d%EzwRBD6{20#t0d zpep#PFa!Da7I>+6AsETkv5%~m%OHQ-%WtKr;b;oU67O4W+i!B#dcrFB=zdc*xB@ujkiheGS%iz5h4E31g9?~|zl zq2dN=5fYYT24=!Z{NiWE(3C9APhbO`EL)W11tQBR?!d{f2|!t6O2}+%o>kCnyy#!@ z9VF0FiKhe~m!k?0yuNkb-GkdjT$HOLiJRTng9 zT8gY8`Bjh8=z+6w=zid`C=i0SlVpkrm zr0{H)f{S*iMp7vp7~^Y@RrdKqRiqB--h{k*8!U)C6%O^rCa~v?>;z^ zK3*;1gTGuSH|VWCh@K$_2Y@OANdp&Q=@=DzJowadK{zaeKY zZw4`3xuM?LG|a*tDtm@K5|6Wntg@<#G~|Y3Pb{(Gc=n$QE{r!%V( z;xa#{-BQ1T{56T!ofGG@m^f$PMhObsWDXpWtU-vyWsmQZjVvr&Ag9$cau-lBvB6tM!S(bRG;3)9U0v&VrkHjCT$p9pdvJ6SUGGOA^Gl@IU*OW>7#cX5rOIt&=8IAoANQ zc7l$|w6vh6{FIX(u02jIi+Qm5gu9@pv?c&Uw~Ebrn%( zNZlUGskqz z&=KAAUpokRcM?$#j<1V{u;&{@B1}BG$Oq?A8$qhH^90B7BV7Fu zE-?7k?KS&GY#b=N24MQ-={4%M?m}E=BqUy4fO@rFEl5FJ_$cqnCLdJeUoGBv%8+qf z1wIfif#?RoYOcRUhw5hFLp@jDu>4zMt6f=WGFsNl4cMD10=LeNLeJy-r!dm59hEzV zLcuZPLtZ+;etV!gvrCw^78Eis(KcnvAo1!IVaW5U==hG0MaSK=*RKoTjPFLC3JguI z?)ZBpg&ra?rC$C$s$Qm{^2g2rJ8jn1qI=sl;5xvOUty}Am&9);;g-;J@Q?TEr0y!! zdMn&_VIaXrjwfxcB5LeY<_#`JN#F9F)jr$YhPRMb;O}BdGoXmx?J361_|IsibO|Ld zSt}zst1j`m>>3DS5sMOKVbV~>rH2WkEuWts#>%eZR=q@R%AF-Yeh5%TI}%~CV4! zr;H<47hdMAVfg8-6I-$=>c{lL)(cbzbGyr9Ck;R@eY)~wzIuifRm9QhYWq-v@ZI}) zW%MR`!#l9*|H)e2abqT&4&D7D3Dip(MZfbXZsS*?5XhG!oeNQ?^Z#|^*`@-Z!M;+$ z|Fr6V8uEW6;SDX#f3VayS3h6;3zouO1?{zr4X+-^dW>JoBgN{3bbu8#q z&ic!{B;HJF`E*)*8PJ)-Fqu*HO0kkP&*(pVQwPPhBSWX$<=mcHD$0->}JD?wTzAs3xj+I|++=71P=m)ctJAX_jP(2Mg(|_hqX)A+t8(S_GvJPoqxdJ)-GsV#><5 z*;t!nZwG6u&^oz4thI!$4KVe^=)_MOUUY26!9%AUZRXRlkzt%@>$rJA(fka2GdY2Fg0AoZjJjsaY95l)nJp3b%_vR% zq31i8Fv(tdACQ93bCWPvo~rIuv5l|ME!`mv1)JK!{LWYRI4CCBDImgull88FULQ z!9biBr?BDNfAXi#6)=rhpTFl@k6mNEFmSFb?tvF|n1`h+bnaL$ett+Qi8h81j|0%o z1;CssFfrpAPx!4$u=sga;z&&AD!Lpt8Xk$tjs-;KWbBpYzwk^c|1n2sKk}%iSz|3m zu?23rn=`AU@Xw_vZA^s*d?}#BtW1vP((h{2UNE+x#x~}Bar#@;_#k)hs^bKBrRL;OS z-#B(3!=6wRg7{9O2O}^7udEvebvh7qWiO^Omj)G-a#|~5BsQ#^h#I8?;Q9mTr@=R) zZ~h3fpcd)5III9YB5{NZ8>p8B|@b#o8GU9 zIi2C02i=DH1n?7N=g5u_E9C(OeTo=4|1SWGKy<&yZEwq}GWD@6GN*RfMWEx3VgNeW z9)ONmt>Z8T%rglwN1Y9W$2$$yB+ z|ELXlRpc20E>Q(>Y3)l?4S#%4AQB>&!j)5&wQ{x$XIH)iE3%Tyg6bPXqm@ZBsyP&e zkwaNG)RU!6O0{ENHVr{5v{2q0X8TB|H3d*u@lgG~dvFygY&RiDNxp?{ov*# zw@v`kj7Jd#%U?-nruzUtyc zm>qsnVj0|Jn<^J!YJ`oio0W zjHHk%{&Lu-w1Q(u{_J5NV3-{TNF?uDaANZB6AY@`gF$K5(f5i5BXZ%oXb`s&AX*gv zJYB5-_8aaQM*IQd%vA|q!yaS)AZ7r?0cTI3w3C!W(1v9}7hwgH2!9LO;|L2Tw!B{5 zl*c36jdj%eorBY)AQX?1mVwHfSHH5fR#hv)V7IsXE|?xW^yv8Au7fvD4%8;>oX#o8 zDF*|={|M%M4IXh2bTF4F@Dsxy0du~N9KL)T%)LrKzibR)NBxa}Cw=fLm4A1{gT?LP z#K|k$v+*6VPkFJB@qgD+UOEx#&yIZEX5kEeIL>+S`zp}&%lw}sT{r@|AZS+!m&NI@ z!I%x}F2e(+M2m(mV)lFC=EQX#Ii=l6yj(E%F zcw4IknVU%PSFssF(WDD3HwLuW2u>a*B9sZ?a^eqCY@QsY*nd248Bnid*TZnZz>3u> z@Z3)2MDtyg=W*acvvHh2p_Vs@V{mw5w&lTP0-=Epe^Zf1VbdJFZ_SYk4%ZEYU+CI% z`_$OnHs{#`1CZDL#5e*vd>Fkw+)z9q*4=@TC`K5W;`Tn-jATAynUC5`B6m`xjJ34> z&Bdw7@`>4|Cw~|DL4WX!N=k`BWssQVwJ17u;sfV$z)bXv=KFwW3a+nB_3T?#n-V0! z)ok4+yTDpZpy*g(VjC9E&#lXLbXp0_Hk|;DW!wV;*V&3TW!m`|qde(s@-=g~v}u#B z>4whK`Hf=s1`~YU@&EV@>i$s$(-U|yG3VH@G7vv#aetBmY82T+1+I&~u}tKy8_NE= zk)DcIXq(ng(<)~o4DVm9pK=BTI%+VhUGg1g#WKN6HbkKHnyyL1E$I=!4U|T^mja;9 z&E!D>hxi4-vL#EpX9OH{DWM~H)7RLQ#l+K%pwA(x3^hB7b)7Z^gUra`#uxjog5Il9+~77N3cIVbVrTJLS1(|K`P{l*|G%mlC8j;>h6K7gKji4fPL%S7K0~P@Mt0xkuU3s zF#aMAuVZl79=6B+VP|vm2s`8D+jYUC1%K*8{pfw$-*A6p4#&RtK)ooj-oGSD*L&)D zyWSJcLln{vB%hDE!QI?}Kiq-rl+~m6vj%O(KOjdV_D43t@6!HQF9;!_<_;UmiFXhO zj=ri9u2c-ZZ<&K>0EoV(ai7!{=v-cyCrK-q7^IyibutKLTHxGgYCtRr^kIl;OMf2> z39{RdlIH-^_LkP^+uTMshFNNj0m#8MIQN}s*e-WDc;u$Q1&s{^E}f*&+v&#>t&gY# zDoaw=P$bpo1JL7?iAen0G67Sapg5kzdtJO%oeg=2|0?J7h!_W+3c2`#9P@-QoHu#$#JDPWJ_Y1A{CPIc>L=ZXrL*Q zqQ;Y>_KAHrfCfGQ-Td z1E>|Nx9eZD4sYJw{%e>66Qaokp<@F*ZuEbq$FcJ@sp!W%zu6dV*1bI(ZJYI{*4}J% z7_GNWi-mao9WJID(l@>P>tl;-l%Z>@o4kDqyG1KR(*MBDw>vYtF3K&qmuRR zf!a@X*;CIiGL)yfwN=*Jf;#(#y86APhORuEpucQt?y!dq^0eA87aL_n7^K9D=Kz0J zRyba+--c3B>EG`ra$9XkQX3VEB>h9e?VcoDoyc_uk^#ZpY*Z@O+Z!dB_3UELQP z(^%NGSy9@$?@-b(_N$18G8ujLW!E<_;Xu`9%WE}#Rt@Xtw&U)*J}YaKw(Dt| zgX32Ly>iv=R#bR>$+?N8&}rcLYEFOs@zmeqCa-Y$xzr{i*_cELEzR_-NWF+_lH+7U z4aX8|zn|FpUFM6MPy}J<$NeIut}HEl-JzT@ye*XqF-*%63 z8ArlIgMhxEZ8Q1|=Z}@~`C}cA48I#z*>2yQs)EU8UQV6mmbXgCxh89+fee4ey8OqG z;_x)2P>vQN5;6(onSEJRJjIr~eGhHHh)XFX z7d>|V^=xmS#CB-HbqR`SBE5gEn|kxfwhid8aj;Z&*kLA`ivy`$vv%SL#BXdtg|}36 zLc_k1RNau?9`DPJN0s$#bZ7IXE~s&zRZLp5<$d-%51rFhci=UTPp_dbx(BIiJ3G^D zYq>P_SWxf!@&G<+IJEHHu%|H*+Mh^dKzsh&oj3GL7nUS zvb*iCW!+nFFa09;#zsUinAPamHpMCTJe>vGR8@l{-w%=@_u)+iA-j7%Q~X$q5Z&`w zw!csF|K{E3uiLV+e;0qp!xdAQFu@RzHwU25L)dlQ=uRzLg`F{=94M!M!gS{hIMi8W zK?R`n;fRGGiN=wEF)^8rNhqAd!r3~ohKN-+J&iqeq)gc1EEB#N&+6L@kqkib-Z9=5 zG>2*rJc&1B=Z?}K5-0ZgSs2~>!kzVwJUar>ws0W&*T!>maf5%^KTTf(Wd@8uVMsMZ za9Cs1f>uH;XaID~Pt|!i=@*v9`h_FM`sD`TIk~vabvq<0d+sYh>|keGSVBWQ;X#V% zb&?N>Xj_As{vSkG*bh%Mxi|onbhuXfXg|?#?EO8Re8R2)3*c^uK>!>?!4GBO3>CWS z)4{f7j-fAB&&Pj&wX7~?D}gUNjm9oX%2+@U_;JB7k zc5@7TTTZ(qi*AP8M;uU~v@1r#;?xcpkB$R3LgxYNcz=HrPcnlg5BgKn+viJaqZ5%t zgRb4)Kw|Z9>?Loq2Sl@VN2(WuBAFhkuefArtqG|<6 zF33tqK-~O5+le$as~{4I3RbOMZJ+)3Vu{gwD&(c+YltMkB7T-u zno{GJ3IdU6^#pp5A1!1WomWV%5OOg&G>MQh{v#5ZUZMfaz@#wL2poyQ;>u`nRw>&R zWb1!706$W$zx&u@^igcO2gpedbbc?2?AVtG)gMM_?MsME20eR)2GTgY&h1$>?TeSM zE?nyz${@&2AYV5|By0~CR2UPiVJRw17KWCPaxX)+2p>YIw#=NB8wP>-5?Ag(oH+Dc zrTtz3-aoaLmL*JqHVV?PU2Zp| z?anL3(+emGs-%XCpK8f-r6SP7h<=~-o&l(rEJm?R)(;stxO#`&E(V*B zu;gL! zg|kjajVG)3Rb93ZiL9u2dRWmelB+<v1wj)UsPpA|;e!x0i`*X8Y0&4lU9X0c@qW=kNZq!w`+JqlvrP<1fakwbl0 zId4wK%5US~9lxHE(LvI#YPx@-6j~0K{GVtHhApEjCIN2SkNA3#b|u0{`5_;d7KucB zP8_^BLExQ0Q$EiHpj4Z&y`wIrrQs9+%Y?qMd7ebycTm~*NP5%kh-N@2M26siXa zzUL8UO0~R@;FRRa6N-Ks=jtj&i3p-_cBXMMJr1zc(UXl_R!I?@IjeuJ=!Q{?=MjrE zmZMXJ05F=cHxI{x#DK{TqXeg8QOGwUBQyIM%!;FY#&0xL_M>0SEkf=pJDW@%Ga zfa#w2G^5o3IujKJa1TQOLm>mhmzmcwWiuM~e%ZX_qNVGrmR>Cpl|V)pE!dTs#-eHZ zIOM`cfw?rR>0T`RGh^jI^VIk>+LemZIo%=!{q&`7C|@qWQ-HqcJXpXku4!?XJyo3IOrh1P7Ki`Ch7J^vSat!P{NC zxHV>Wq6wk1GD0^E1(BZD53d*JO(p5KJL(6Pk4W zq9-n@#=R6kY5adn21=m^NtOo-&_{7k;7)cHst;-C`H{$_ias}$ChMs@dA2y`u|wiH z3vNvK+2BTpF*qFaD4I@O3EpRg9Ft#A2|N3Z@eU7C$tkr&CTtFLm#D{-|u7`Mk*YCM|OW&c}1$Bh} zFe~f)lJsy|P}S@8?7xi&!m%Wp$KbE36W+D^?B&v#MM9tXcZtcApdpTggTdQ68Lz+b zRFd9BF~DCsiMRc;sflCvD+PYL=0FLuOT)3HY8rRJ8Yh&tVjJDkcfI90|LjyX{(=`9 zNkQWH+Qol59AhBU^DTwjzHiBraM8Ls?e?^DKafM39{cnNOYX{c;g)`Ht0O809HDy% zq5X5@5L)&6E^FJ;JtE_njBVKXXLh451N7;!B+3E&=M;Ac4aM)v9f^i-!Q$JJr9{Ft z{AgzUqnXi@q!2p}^w_BBWRbtFvmO14fUOVI3TJ=T_x#KWK-Ke2yGlS^WW4YoiPnq; z7+~I6;(Z9BoXdA~;{FJ7_eV9=UCN_JDd{Z52?G&D(e%HmMY~CajE5LNd;$}!7vCQP zHO_JU4^NInCdr<|O}ucxF2-NzWb{VN#$0j}2FAU(crKh4YJ4(UOt8UC3@~{{>PP?n zQmGeoe@1OIxaK6Gxv`u~`tJ7G{{W3wVj>L{`E(Sl)vKHnQe;# z_Y&I_B~cXlBPr$6yEosc)uFwStHVmJzUrS}+}(WoIu2J#icDr|b+=z7;VO}tkOsbX ztM7wNVcXkv7)8MkGLpAH-u-{=MnPY>Y7Q%UdGpl`@Wnz=s~;O^&_iM0II!n)S>!t! zsH^E|D{9PdRTTWv<<&0Vt^Z*Ujjav^HAca(8?CKNB{ORjtq5~5~LZ%v);Z#r(&rDB3Yvnm!;E;bwP}SWa4)j^A zjShuTX0=vYL?$Edx+xAtWpNos4GX+gL9--H4602cKh-Zw!o(tpdvQO*aZPZnan$=9 zf8U`B^5)h^C#nfqVKDtqby1o!paMMY0bkA~JtANNIf z^zFP6ps#qWFQt?S!_;dGC$~+zq*>!$J>%JecJeN7Xmm2AM`uZl2vxr=gLW6DiIhlH zFVCi|w?7L~L>PmpI-F|a&Z#YhEqV3DYkUiXZ~pn3NJUG8?r48IqBt>Azvn5MT;1%z z0=s<4-c+hY6oyY)|JeA`EGRmfh2~f63_u{Wv0Jj4)NeYp?8zx{9Tn(QrNMz&&Q1M; zlwrw?u!2QFGhtHme9sWKYaN5 z;*oA!|5^iUB&B}`BN=@8-&b$w4P2x+*{*JG0Ug8yC;juUcQ!Ll?Qi~lHN>dDcI>gyB1vLDhKY@kD&n!`g9uP1yy9bFsF^r^D3}1L zPYZ+#N<^BCgh?L}Qdk&lbF6<13=q?H$3hDTSxU;~-Meyo z_p*1koAVdhvP4@R@ADP1hz!JDYa{g7t;x>Sm@`yj2sPWfX>N5AZ*M~Z4IRiw-}CgB_|n-qmjoi=viG( z8;S)(;}FQ&enN=#>+9yxvLL@OvF4riamMig6oLj#n6U34 z5iF-H$1CzX1rU$3yeq(pIG8ikUMfsFJ*u+p<&XN_)bBWkz&FI&U6EHE1yU75LJ?0z zxblB+FUd!Y&Z4(3mpm68D-0q13lX>s&H9QtQ;4EjA~{UOF@ULvByYGRCIssd5QsQ~ zFg0-blzcufBpyS2e!nyna2P#uc+As76@1>yHeN*nc9;yzQZ9ms6tTj@AZ6i{^W#Za z3n7?5W?=xw739}|TS(8K^Vg#e6N3f|cJBZTV3LdJlV6gA# zxKk|9tG2T~f1KHJB*G}0Ir6N)9Xs+1HoX}7C3=$RU>bsrA?Pf9KJ@B86ncO4Q$_{3 zMm*W?aZXWh+PvXJkSMzX67*t&DdL54HKd}9{h@(BN|Qq^Jk2!H7<8#VxYrZWUvT2G zM_b!-HQ@@{hnc)SQu@cK-K9i`ToWg8GJ;-%ijB{>4Q}<$S=8pBN2i!)%QO#OP!XFj znnlvNADbcb_|l(+Jh8FQO4|Rt6i!1>5tMnez&ussT0@p?QqcYdTz+Y{*`MG0Qju5C}muz{-+r`kEX-tXzp7T1%6u>9V!AM$o_4(6Iof(85;F=ufB@#F;a?&z>gXF+{tn1Z0#(<&F5;LReC zQ4A|eRu+&Ut>7*MC^~=Z`=0X#aN^`3$PGn&k6#P`)2Je4Ok!y#EBuZob(V&r>=^e7 z)-2%e;n0JXKiumv_#?{AeO;Dx3{3~$(Z?PHf*DXabZ{5{!EmQTrwGLl)!&qLO__KdmIenwzJ+w z>eGDR>CUUauxN9PEF@Z@_!|%;LHgalx1~kt5K5h7e9;pbz9s`HTDo`y!HNn4 zjYoJoOmCiE{o>RF|BoeBVA>!Y~r140IV0>cj~F zpPQz(WU=sZkKXIWCQ{8!ZcgaNcMC-1F&N?LlEt4>W8XdZbtVYSbU%wN?$nzv~P=lVApp8!)-2Bj4f7*VhI7E+KzvRJLa!X=eltP{aT~pTX#d`c2sd@ zas}q8JKW^~{?nh*V}Hzx*5i~&%WOz?TF-=LfNyNFz_WV*h$yzq(c~rft=Zc!5s`D; zZfo>sEgk%v=*?YiKu7TPb4fk|)V_d5NB|sV42PEHQdK?M)E<$7x*Y5{-|=M_OfX6k zTjGD^a4?>3$s9L1SWwQe05w0`aD8cCjPGD#9av_v^Z>_qkr3Y*Xf$V{&i}`1hwtHP z0{OgM?x=CYOngIw7dbo`n9z26Y4~3ObK%`3PssnY(V-bRIW=r*z<=93+ybKDdW>ed zNy)(BZj7MkyP_>z0)fO&Hf3>cKcN=l7)^hIUXx11b0oiN>1kO4${K&R4NlE--t)K( zD*Kf4anfutCtF?UC{0Ve?mL%u%eKH-JJLIvfIe8=a+>&K%SheuMc|JK5q&$ojYpm9 zN$DQou$j)_-1JADkbPw`_B9MJ#>ylRE=ampg89~eM6%yvM{$5CeYlo!P!=aw8A*Qz z9c(KOM<%&5N6-`c0%Eg@2_vD2j}Bpou>xog$db>s|H}kW_P!HOn*>!3lWgh+_h4bW zCPOY&Wka4lz4Tk-(JS8ijZcuig*BG8ndarF<5c=nv8T_f&P~0$Z2S8{Zz)bX%4J5G zeLMZr(g~dc@`TID|4WGr-TuVvWV=}54Dj*)+-Z>rv-GFCg=4g*>dNc;39Je~GCkYA zw~cr#MT-pVXf)haIKT&MZ2DW&-+a|ODDBV`J8!1Ts{d@JBbAESq)<#nBFotD5;b9h zy7_-tGfy*@kv|d?0Wz1t-vJW@G&3_emm!$}D1X%($+F|N@jhRnoUB(F(bx&v@nN!z zf683#kPM& z7TX0`e0_HP?W<>>zf^2NNmh`8E?zw>3bM#akr4s^HjD3j3w%M1x#tbZsGnGk%jVl1Pqu#~>qnRnE(FZai$K5Xs3 zUEL2Y%)PgN%f4^dwWmZa-_*m--VOGBx%}O~UVLkZs(z^V%~ z$m3s*xcWX70W;m5E-|Xu3E}rU5R}VvVaD#`4QnhrPO3WK%g(;@SqY@(1jNU*Gu7_v22#C=a z2swLM0{aNb--jcy&d3)OUXqgGo_}bLw+qE#oBU3zOx(dSA!PZNYA834hjL%9`Zbl+%VdMw<&af*DGPc~J@+h177eDvVIvNhBaDN`%;N#J) zqJ6N}b=&-W$K?b@Qwmld36AkET;b6SXNGqB_gx!WRC!<-bLN$YJ5D=>N-Fyf+6QyWDH z(1v$#J@u6%u=fmzxkX}~Vt*OMG-&Snu&$40A@FzI?vG$14nuGM8|E`@6ouBlviW(?A2*tGG`8`;pj}Ep^|XSoW6W(VNi307M$u)^?!baWKj?>Ns{v@jIf6wx3ZMZrQoUy>u- z*y~cMvRsW@AE1erz=OpPDJ)l?2EmW3vo6lSAfpMV#r7k>)v%)@IgWCGU;-Xc85 zSA@8Me9%P^`M|vd`6JX<<6cJ6QH)!;NpUpGsh+KG#wH|&M0y|+K$fw|Ib;bMEMq>D zhJ2y{bprg7=LT3?XcUm#yD9%n%t!$v1U%>_QGQ(?D60=-tPf%lfHx#HB0#+2c+FW# z1W3lfJzHsT@P8a&o!nbS<)rkJhklaEq~?(s_^!A>3SOfDGhx=-qoZF$ssWr!KumR} zM%5t5D478yK%i2JAPGquE@h;EkB8!lw&CxlyX(}1u%(n=P;c+9mt>@u5}bhD7x@H4 zl4~oB%KbQN6F06+7W1Q|qr-@6Gc1^?mS{SKmS+SCb$|1@FlrFB5T*4vqd1RC0`u~P zWUyd}OCYrQ{s*$yz(a7VG6BnaV?g%{mBSH1o;8c_Aks->L3j>o6a-jOP#iuL!cy#q zLm=UHtpjZ_0M6%2J3(r4pQVtQ=d?zPe0qZv>W6~9M>Zm~|jR6z~1y$r0?pG+U#&OczoWs31q9W4-j| zR5>a!hQKKuwdyHPz5r~+xhs6hW5S?I05Xj5aDN)h0~c-zqHOvq%FWmen<|#avMYh@ zUA=bE8jP911Fjc1LqUqT9_c$;zL*HBZclxZJ)pTniaTbyhiN)<6L2R>8fBHSNm+iF zWNA2O`CPIr5r=;0PHP*p!a(UBl=jk}Fv*t_BtOX{Wo#9hy91%NAVfq|dUqhEQD=lj z!hauSLhUAlWhPw2o7`2$Q_}}gDTF+QTz*}i`W}K{`|mYld{;M34>tniS)$-bx4i@2 zRrPi^*n8v*UQ2sfBb37uCRS-7Eb~f#ROWgC^zG#0{WG~Opu|}b$TyN@y z%FUTJa^f%@yTO9RC{~xGkKtp8hhM(ho{9SZ-4G! z31zqGXUGo~oSJ^HfA;kO=5h#)S`I-`Ra6g%>>Eh0KbQx11~fq%hyK$vjk9icUqA!sTncm6P6p zNN4}TC&=ioDjUaF7&(DU(>0H-&VN+InZgM}f~n`)7hSwjwSIE0ff1aJuhH-kE5;i% z;47!V3kYa2q6kk;P%z*Df1am!pz}=7_w`IaBn$SjrOYIl6(*Rw3U<6gsS|W*N*2I{ zsWJh7w!wit*r5U32zR%0H^;8MFYoK79^7k2wD5Z0SKZH60K*q%W-_&M&VRAyl+WW< z9q}8jMHnFxo?87%DA;q8RLwI(YKz} ztbo2%67tM_(Ug8{MW)`z&$yAz@oYAQK9AU+@)W*$(t!V%%<31qh|bz?Q;d?PUKv2W zN^K?_Y)NN(dEpq%_Y!*#2!C2TFHQbhHht@)$q2m_wBVEo>C1!wQ`&(;WsR=+GkM$y z;XQ7r-NTtS8{>T!JhO$G%8HW*VIS14+SZ-ifbFw@ zkwhb-(`6WG&ANpp(nvW7nvqJ^7jIz zO5>>tPCtPu{s>%BVSjSem*YxTw2iuXi1W~bTJGG(BWKlL_lEcB$Q7TC!G=-xKjYJ# zdBQ+^Ut(zD^AJ&QmtP;Kzj}z$6)p}pGM6rEQfey`pe!>Y#3y4wd;$v4)T2;;X6uia z4gjMWlm8FSD4b@!{B<(dg$+jIN%(WpBg$#U1&cDvD#$Eztbd!vyZGG+Z3-vUpC!zl z5@wUBFlv*jaAW)X@KKnC!Y6AKEqrkAK*4a^Jf$(TICB5!UoG!VA783pEsqw6ZF1F1 znDh@Y-S+Wi?YrXUP9QfMG5P8ssLK~U*fN`ghFK@`&at15(uDovRM~D6yfKT16|CE) ziS3kqKK8iWH-9GiOtFz~-JCZ5U)ePFrmN7X2mL<>H^s&^P*(mGJEt;y-n7_1$T^#6 zJ9gEkwrNuQTXh{C?2y3D45pKny=w#^K| zwr#tyFn`_2h&y!(j^YVB?eFcaRbaz2Ad^0s(iWE1fa3{gF;AlUWAFGBRn~4~#TrBGQc6gpua$OtMPe zX$~aUbFn{PC_7NkwyyK%#8~Ci{vyc12^PG4a9EJKrPB zV1Hl|%zslKV?pW8+#~bXgY8&-ZWD^-1H6Qfg>}xc!uQjuZtDAP+$HJa|CE}MMaK16 z3l@#~MhK6c+A1AMV1ru#

>kTpyql z!QYnrtj|e%Q>x`?x+e3loWj7f1lnw}Wo zZYt+D^OAn7s$-n;>u<~Xp||?N)Y~!l2IuNf&T`y5w`Y;N&*I=}_kY5T?HrKv6ai24 z88bW?KVx=i?%jBQ+V5S(e#C>{C^wA*^aV$_h0_=Avs*`;p|jm5fs;3h`j@jOei9t( z%6~(E(RPpit8JI>_nzmtd&ZG86+wLZ=)c)^iP?C9_Bgd0#5>1@?H~`cwSPo%UQL7~ zw=Vh=J^i&YegqC+m=dQI1oVi7&EtHsBLvwh|8{6@>DvD{qIYPvdeb4 zXF9o*^`Iz{B0o~9uOEK?i3cb1h6Sg91#j=ZzrEq`WdRTJILPuWikS$i^BXr7m8A$0 z5#?nb3@Uhf^Y72C7mhsVMZ{P>@kp{He_}lKytYiDBEcqpc35r1nOG$}Dp>Lgfl#3& ziusK}@q!$8Yg0j5`~{0l-)|q@eEma~2b@JED|ztn6cnIWng&@>Mx5utLmj*ivnYx9 z;m8?d;lm+M!r{P+P)U1Mojn}ml!g5heQl$t@zcM4pvGfAcC{R|GKY^3|CqOie|_WS zzDZOTJUGT>#EO)*{jmcMu%&&z=t{QKF_r3oTW|cF+YcIV z>2p?A*3X?h>&mmZ^cK|6(*|#^Oqo$zjko zPFrYI{rNIl-JLwOBo4xv!E^6wby4us+4k8>{SaqS+2bMCjF?4=C za0cW+`FzD@Kh*9_$s>nTK#iZ>>1NB*Wn_`0B$JFry#*tD!6ULLM}}^Ne|EH6w$K#7 zlTC*9G%Gf+Z&}0>%_C}9#9<941r6lbT2PTkhhxIh@S$<10Q22=R)hDtf`{^Q8T#M# zSz6t9MB%-%^$ef2YHLH(owL!Y)sMPWG_8iAA3Sf}5gFMP1_ot74m>~SLphIF!q*m~ zaLQTu-rEcjU^saw0E+_+e_xps20nsX0@nP!$0NQj5BiX>5PcAWxgHg6KzF0I&one!<-5N15*nJ>maPNcp@tIT-ckf|kb#cbWhTFCm$+gRJXTIf=-$8F%LT+aXOuKkSY6 ze8^JgVwv#3ncYNZe+U7zoMiOg2VVj+Ke;sn_*FktlK}l_jjlZ@*)pT!L&s0}6wevD zoiroB>5fk!iAajjN-}4M-Q3B8!w~pZRo2tsCO9jrY8+(cu#l#lj@U3(LfpGEMoP4{ zo2SoOBP1~TJhsxuipb;HGcSHq-O;y_MwvC!4}kKWv>-|gf6Zi1y+!_o>?$0hgAuWl z_^ssm(kk4XQJ^{$#e!&wqHKcD_j@QSA{Nge%Yb>3h2P*O4|&1%I0_cUaW*aaxW^Rg znpn&k0MjuANlThIKL#aax0f5T7*I5sR?F_xs$IcZl;r6|R?TsUS;24PZFOzXHE@Jn zt;Foegglv7e&w1n_x%V?f5D z09(a5n5>{(zbD`u7j(>o(8ID9Q5mZ8?UM;CXp}_kW4&-8(=6x0NgvuX<8|rEtfl`h9Ni ze=*(2Ix&sG2YHeIC27$B;K6zFsW@mN)gSl2boZUTiI1=V>h6j9@UdrQVunsjs=Fl3MPs%zU23DhSWWG=H~3oiv?f9fwvpBg(!%oyL}BHjbW!+&&p)+ZssP|fA4K1pftGMOrG~kAF!;#`Hpgon~HnZCr_r%}U`pdWL?LE2Z6JJJVS|^b*iO?8hR1{lO8m zEW6s^Z@@DNQmU*o}0hFox3#ur5?UIWX z5nLwz5B>>Hl9!P`5)=V8m%-lw69Y3fIhR2f0x5sxTU(FgwiSM#U*WfS&>e;pZ_)zW zBAaB>O_3s(DHd%K6dIXh3oA>GBxhn2{qH^Gp)T~$GqXFhn*e<>MN#D8;m7Y>NPl|y z{kLqf?#}39y`YP)#^0BhXP>@O$%0Xm(TpuFuNP@bGOiYyW`qi;SuK8CzOK(N5-pbf zrtE*PWX_pf{+4fdm3am=DP7)dOlyW_zVPdLBA0o!_m9o>`OlYM!+>f&Ad{NtECG4k zSevq{-ju6;)ubXZ}2z4 zpLJWVu(WGRXym6o&b8mPrrR`?Z!{=M{mFm#{Q`fq6=!jg2u_q_iwnky6d4NQhfvZF zVap(tRrSp|qs#n&Z?D^C8`ET#5iQ1P?RPuVzJv*_^7ar_f-4Tq$@vAB0+(713%sk! zqU>?heO=MC=JvL(BgbT_pnKh_Bjz+g`z@-FYpHjRammJ z6OUO*nC78GmvJDlj3_ZG;wG=Ee@B0pkV_({99P+NeVYUFVQ2xWsEca9GFCA{!4uY^ z;-F$iLHK3|`~!URtF1Sm zl%E*UDw|=_4Zt`KFyO$>jTpP(Xtw02Tw(b((WqS+@`0Z5fnHvjs^Lwy&;D`^mYKOaDaxG3|KMFR*EV(!k^7iB~w367b>RHDFO+xeyf8@|mTNoUW#RDS* zUyq*C^C-W8h9);9t{kQG+|iC<6JW)Y+u*#z&xle(K(@{qk0Kbf3J%D?9w(O+Oz5mx zd_|!+jF%w|zAf@9rprVTK1B-A-U9KrP38SJunJ%vp+Jf9Fud86#RjZ@KDhE=koT3f z==Q<7Hug6k-c@;DPOc2r?%L)mzbdP;KVXIT&|`XFDeMv^-*f$r4U^C#5>A@{PBL|D z0YX&@2iuFO;fq-87J&C{1PPL4Ks5~&~ ze>%l8Jl;pblKWh8C?e*Cs^ok*`c2%uVL?=R!o5lP z*rI5gt}`Cm&V9pz_d&tW6d84a!-(q(zh}T{1V=mY=qAY1MAXwR#jR5q zvx<8BTm$=w_l%>T*=eb9uY=S!4B(V6ulFseqs7V~s)xAGf40egJO94w8vN|a6wTIP zE&ASd*=@>tT^+DNw*^PmsucqB&-zeP){z6}^H{4cp0FM^m&-%5w*|V~y8HrXUMv@e z!IR5_!0XP$;lVU`ic|U~Z&&}gPh**M4vGH+28i}cC>`4zOf-+f=5F(K)5h~lu&eF{ zM?m3TEf}f8ysP+syg3+~DgCfDeSR{Qn9cQVJ;rWUwRV-zWwIaU!pON z09KmR|M$jAl;dY;INJkO!v3*|ERdQlZ92i$HMMyTTSn+fco+-6ZehpOo|C|a6U~m4 z4wCPS-eo3$%B~LhYca4o)cLk7I;`=UhEfNbseC)2!2tuAGx}JWw>vDBbpZ?Cnc)e4 zuUlg-WebK6+ml8J=<*6Gv9aXcc^fg=MXFV ztGMjB0q{iy6EmXSHg#FptV%q`&500MEVl+@xD@hSoWyGi zYRbMd)wN4ciRIrcRE^pBS2g}_%X;N_5-b*id6s%>&jnrjw*$kCvjXL08Mq$&ct?TD z+x2CCk$Y-_9ca55dbDaXb>aDHNb?-+I62s`8MRfW8=QTzJ+^aWHhav?F%%nKJH9Y2 zRyqr8`!qei^+_={N<3xz*p%FiCBVS)ifNO7-j~bF#K^EdaXlvFlF-ap(L;kDjC;YA zApGdK<9^4A&l9gs3v5VALZQpIzEtnGR}<_KKDDu~c3t-V2~Q+k(Lso*spVJszU#`o z#wU9U)nT#7$Kth1jM|}1?>F=$kg~70W@yp3WzknYS?OmIO#i0rH*P=8AqbIQ4_$zN zRvp4_9oPj)2Z)@w2A?3wY`($Oku2j20l^R0#?~yZ&%V3W#q4{I&B4Q`VB&lq0+x!} zFv-0I=`yCW8@v3kO6HCz_r-B1Ofw_XTu8X%tj4LD%`ryT-d2A#rX0+ zgpmKn1Jwl7IhvxYswv)jdG?)m=B~V;E93Sc`dz8db?C{%`@E?zs%eLlFA8XX;YU{V zmTo!t$F`=j=O_~P%WIcSf!ZxlRo*ww`2(|t3t-L2Y!O_;ymc1I1E^guu<*TGmykAX zgrAL?DnMi}?#ZR(LCW7QgY>*@hxRir?Rs`7XX))-0wPvu_Q1qGOg`q$In&?>-IVK1 zf2W92fPUpE5pTv0>{*L&NAzKT44Jn;!2NIr5rz%0-?Axz_~t~mLnK*n+(U1jk1FKs z4$INgeyw4Lr*|IrLs3mxJV*W0$(fu}KU5FYul$)K{F=PjVAE9z@mPnu8(yquX*yqZ zbvT-UbxJE=9zS<(3A#g|Dk=jXBGBvumR~5sCrce%pg2u6!1>dm!87lFSNTwK+YG+Z z{2D+txK@YYknKVEwDdbJz}oBkhjP8m@7_ilrZyemhc?j$XBknJG2N*^>N8?VB178= z3~nvf!WG)}BCPoSAuR&C3l3}op-+<9)1J|8ri_5cYts#yPPXp;u}|9`OS9la?A~_5-cc(#R9~(D{!d6cQ z+(0b@86cLRGJ9IwD8Qn6PuzGT_gLsiptY&fCxec77h5cX1nuL0(UaJlFf?)K;o_sy zj?E~t(Y;N8$fb6)!=9LSKyQNa_k&Nf?|1wD%i6T-!(%Z7KDe03;^{Fom-S8{slcgw z0wASU)7%5;qw^5W+#Q_(Nj8xWsQwU0vKQBscnp$WwdR+{;z)xT)gKy0R?xfMZtb-H zbRd!$;aP^ZEdAJjAhJOu1Bd(=L{D$cSPJvh^8G+`)0VxteEsb=um0d5ngsoS0+CFK zNGA{pMkxC*AW|IWryd2OAKabOM|(z@y(IR*f#ij~JID%R!N-HiUKwWgF6-}N))==L zMDYH7(Ee*vh1hw$v~^QP|2Z~gOFvRvr- zMZh3e9_!wJHxCk~pB07K^_ar9bNm$#@AjsPUee4sne>B)dh(HZ z%pFqUjX4pt0dn{s$RaH?mytgbDFQGsmvNdBD}Uc}+qe;a_g|s6N;44xfCNEYpRVmC zY46geIZyMD+ygB^GA9(NBPl!XU*BCUz#j@_tG?JXc_ILUz+$oZ_S*$tUcP@PX4~e1 z&$cr@d)+<%a(VIcRU&7CGsBITU2bN^FsY-N=7#YYTGq3V^IxikRP$R~FP2d%<~LZ& zihqM`sJ^eOg;4XGd~LCT&v#XA=~cE`9qO$0wI6s2A*ynsJuST%q31#trY!>G9L$#qSpahT}5`3 z5%am5*KMJs5A^7RNHH$b@I^Bx2VJiC(h;C<5@5kb>%^HRGt$6fnJ~$C z+s7+pDoUWU;wkmoR5eMO6$Qz;stSVqx_N=9Drx0k_O)#s(qShs(ICTcH8N!h?~Zb? zUmV^evokv$#bdkhMs4)SsDH_k)!Tod6YW zw(=kKOP$^uFd*4k{Ff8Qo%7CO*5EbjU0zx*!PVW7aG=7yT^*S*w0Az1s-!HB-T-=3 zc#j}AK9d41)^rNL?Qye1#j(6nJNM)JGuo3lI)Z`!EQAo9&j(z*vVZNZwIx*qJ+g95 zg~-<(3xGmx!GrE>xwgIo*;tG&JNE-t{tzx>13no}aAAEPG8*6QHg{HuV>qbDeGOf; zn{#b{KLFt5(Jh(} zu3rOk6FeR)0giI7bRhkpmp=}OJWb{0tI;CY)O>a40Z}C^(Q4$Ue);k3+jqZu>d*#K z0PZg<^8X%@*FXDi1=xC-4WR`NMWW`OVW5)Ge|f%<`NEa=qu|J>;IY2QS9x3bPB(dW zCLTqRU}>k$t$#mczvkOr*4&FrI$=>V#-#ygj)ewRm3Y>yo|84JNCTJcS#w10>j_x1 ziY1eeWzAEnel&GX4QM$!pE|$kaH5$yWGZGoBR)-Rl)_KEyD=@Wr|A=RRI9nTFL5dLb_{iHGy0=XnCGU8wQ4cCBZNiq03xV2VCFfTQ$>)cbx@FYIVR2TME~LPABB%HYyr@&K0B3=?c%)$O z^<|XI^K+R!I0N0s9*4%hhPdW_9~vi2iVkS=W`7Er47leWXv;}3jsT3i-Eu4+B_}kF z^bn1sF2Kd&bb!kZON@NB1FQh5)rciFBwZI|;2PTNAirN0p41wnv#MNE%m__Bl#IGi z@&(P9j#P>roLvqX+<-O1fg74|>dvTF2YRq6t;NpaJO&nyW;=$3-Vr9JCuA60^ZDP= zQGZA=FDvvMa3Hn=a#cN&E|GMo~8)f|CK1FECIz z=13QxfPuzf$VxquftL364Ji6m4H3C5SATbZkb?>?VAbjQBs5Gsh;jnc=^5jywiG^1 zaX}G-M%DdXP-<9y{5)JxJyp^a{gJzAvGw`nZ{v^nP=d)7YdMS_1m}Em65s9rqL`XP zw62dRW}5aCGu44&LaVKN zY8%i$sF7u1ryxqUrnDC{wH2`fFZF1pK3#0a7U5d&d{I~H!>Xl< zTLe6PN)1YVw$=FDT*CW#x;?Lb{=j_)Cz1(aMrZq}ZYIa>D?CT81@=wq zm#v>EPh!X%&$Z;EFB~!h&_#<~3E2e~uU& zHeT854C9}hymE;XWO`hZX@BE;XK-#tKlW{%w`~vu?>zAN)v&gAL-pO1Ql^B!WltZqlV;#e2xmAy9Cer-@T4jZJKshC{iP+5H&wlJxnCzOg?|Z?=r@lTM4iXr zhZ~1HUQ2QyG-OfGza13f;GD$o=smg7hTdeM?^uKDym3^7;$0~rZaAU}ArH3#R#aC- z$mQit$T;`b<#DWBk72H@v(;x0ibLG>qvA!qwWT^dY=2nzA8CXE z3T=`OKLEpwl;4)DgMZG!#NbFWZOr4yI-XbyN6P+G+IoBUDyJR&BYa(e0?dPSz2gS& zY@JtY+}Ci+;AA?={C2*r%kJLf&7r>qnWFK?US<41N;gR$GX8#kez>Zt!e-@@v-PU{ zW?UUCzt1Q*FEx#zTBlQ4u8HK<;DV@!j1E^q4B!x@wo|jY`+t1%K=#WO2frCi+hdru zbA5DocI4sCxxoi$kiEH*vq5KfFA-39jo&BL(9wN;XO=kKKJ%Yu0S6^_)amJQP{@P< z>OKw!KU=#W!(j8wI7kw^TYYznTb#1E0Y5yR6Lc=*LwO77lEdFg-s0KtZnODzfS0he z|M%%6;sLib4^H{vuR#fOesY9<5!WI3=YvZ&o}5HKI4AwDN@t>96!Nk-iO&?k6kV=? z`^*PE%T;lp%^0Tcl@m$5wp zDwk^90t$b^Z?%CnLsAqa1x10o%g5!47HP0R9-2OAWqPevmVA<&&GxVF42Psluae#5 zlHh>ei$zi7aLD=k&CpM--nq;DuORZ5KtsWR@&4 zUNEkpXS4X{a@?8KI+6ME9p|!f?Y7*TOK7SLz8`-F>bxC3ThZ|J?G$6)%}xFOw^ zp0EG*;*{vXR_j!$k3T1r#$D|R9LBn9sa=(>aqYM|4rY67+?0-<+pcLk zBzL>|*VQku@wG@;stVfNzUyJGO!=~Ey1_Je^kVmHdtoibfgh1BO}`R$la>33n~6pb z_5Od@l*r&EbzI+hGW$c>+wI^h?0#@F4D^?y*~H_AUDuC}c)iEt0p5e)7HbmIT1qC1 zjCS%)$}}1UQcV|}9Coi%*;!CDX>fEoeb38=GlQN}JKjJO& zKoTtJ(R4Sl+O&q$(!T7FU7~unGMtD^!^*W=IXbnq%uxhctlK|z?PxxXPp9*mW~hIR zC8_pA_hu|NcVN?XHO$g?!z1!PRFyf5<#pq>`5whnHb*l&ojaW(VOsbFue+`>V7+r| z(LlSDlm9cbEsxE3w#@9lGRYKA{4(8kJG+D%6>aC48LGav-es15tw8~TcweCm3*{V> zEYjeZu(uv&c@vB$6L0O@D%A92(8GW7)G83H;QcSI0DfsK>y|u<<-^dRm*sI7>e4Yn zT4kGP6r*Wrl=U-i+6<>sW{m4ksYk^0I>}OUNT&ySU6+G%gSYj#J9Cv7K%UNdWbk8& zvjY)nEX&n&c*pT@9A{b284t$7s;+ro_T)Z+U=k687*_<1{PP^KoT)6F0&;&mM@I^l zi?HNh9;CypP}m5rX;#m;9|$L*F6|MmMb254tN5gDcXhSHAg6sK)GiY0lSrstB-G18 zH;gN>Tp#+bGQ;3L?%WKFGt`>mwRZ9PWZ28nsTaP`P9StA+46bmnQ7|Q4Xz!PpnLdY zD8So*dN+4kJTm^)+@dRg(VKr?j}UtA=FTk7K>g&2)hM72fgOHtR$xE-s67KIq>_ISpLG!{q_q%h z-L-=^)vj!BJh&OV|5JmXBLZL{O&`xoPcnb??BR`lWe>zi;4%fQnafyoSJsAj2H~hV z?%RQ0tcCH+gLY_z%mLbEZ~SLJ*#J)Iqse;uYI(hM+m85@iC~fk^Y{>y2q0?4-65y!ZYIXbr*H|V<2=Zj`euJOUd{>wT&WID>g`AT zn3BbrA;w@3fO8QH@$cPeX3-ybnVbg`JM?wegHux!T=D4w+CUf(IzTh|n#(oDaQJZo z!Y>e*8xjzGkh4+(7@P}zCZ+qkQ*r{kjw8R$2^54kn?02Sy?{G`1k*ZZV4!wGn%W$l zwdab7R7Qcg+s=RTiOx`clFf`|Y3vN|l_H`%6BbZt+R2n=Le80Bj+f^mq?u&J)a>7fL}=Bb}vbrkGl-1?PPEdL=n%^Aq^Ax|Is{aP`qHi& zZ2D!95IukQkio%e`s&fK+WB(PFrH^lZRg7f!w}aI%Bni{WrYstZl%*R6I%%Mh(25#dWC@J(1A{x zv$WVJ?2+hiJd5{gLkS|6;(^+bf8lIV@*V1qC8#I715{K&FG6vC5)^ zTpC+>!4_t}_Kf;fn%d$*p_e}$`yRyD*w}x7dXpwDHNz=hN3reuK>Hd<^^H>>DGJC3 zlE}jMn6p_qai_Ie;Z+*k+1+;vf4iFkj8 zE*x;d)VVQ!IDlq2HLA^gWrs6;TG&}9V1}m_BZLL=*xlIzoN&c1c+$}dexf16C6(j6 z(F%uEaCmtfyFKg{WPmqf_>F{xZ2HB@rn62*c*#NErgl0*+(w)10Z&nO6kVN_qsKh4 z?*0xgyxeUl7D3Wn2j~r8LP+&>u?&Cg3&agr976RMVwv7t*X`FpGa6i0As>%s-WUSr z=UB#Rmc=qV4}E(BQN`bbx|=buRX^EPie|8mCQi5_DBM`Qsk!8{UIqRvjq6 zCBf<(lccfi35ekPw(s`TLMiJaNLl+!f6T=)pWZ<)>dT+d_y>ANXaN$jr9pq1mGbM! zM-puWF4&-gmo25)_o2iT&%-C{lN{&KZf)s93(tg@xD?ZUn?}47z*rA#8b1qiI%?h{ z1Su>MxH+H;EeSeSKwyi1cJw*w@h$ymhskLq(oN zEXud%e{LXT5dP_K#&0mk-;;kc7J!wo^x>T`2catcEu1ml?+CxY&vnNCG3M~IztaCL znI-tM395Y7-wp^ClHfP=ubO&e(YQ}E<6^}0FP6u+W03)j;SZ&r1*D$xkJR&9y5r*X ze<>fkNK8266FNSvdfdBo$XHtBr}@e{(LQ0oR!C~0jev3PvMGlktUo;Wj}C=!34{*+ zTkvbxM(ojvtIl)h$B^n`Gu$}=xw;MGC?Pm;W?;5F7pSYYnrqp~bTkP3(Ek8n%d9t- zVV4mUmr3Ih4VS#w5gZRWG72wDWo~D5Xdp5+H8z(anE@z&#ai2L8#xkv_gC<7_l05= zi?@XlAeVJAKn4h6FLq{wJScV}5!R7Bx@;04AHSz4bs|}k)v-EGFv(DCHd$S)I(4c@ zl1#=Kl9UZmK_h#^QM4h(yI_1^{M8{DKZ4=Q?Dtw@- zlBBJuy2zMVC$DQ!LMzniFiCRShp|5A`ZODHu})HdjIe{E0z-#h^bIDcwTi-QByw$e zBPr@)EJg~XKr5I44QQ(v%%pwZ8H~k}5C;oJ?IIIA6P7@K@O2XCCI>gB}H=esbG&oZ3Pphewq{m&FW{sK=9qr12!{8u9HNx>Rw>&nCtgI zY$!#4MG4*{O0`c+f|j)vOpu%&sa0hmelPybu*hRrkBlZ>Cv_C_vUIed@}iL-e`wX- z=IzO&M{CR00Vjj=#k+a^{c<$^@5$iFWO~(1>*Vh3;Kks#!P7TXf2cf{bMr7R z+laje;#h|-^g%382;&}`(^E4zH-qPsi-{RLGk=>c-syjMe>53eZRj-zssSa!PCcv9^uc);0#+|Rd$B&RgkRnp27MRQdU0z z2HZY@_9Fmo^@FMz=ntLj)pT-s-e8|#SkKPP;G+3FzrFQa7FTG8#g!v0uD)x3YP4B3 zjW0aD+(VC})9Ux12@U%DtVXgq4p#>{X-nnv&bb%Au4| zts2xTs3)}=kcK2yd6k-PQeu&VEk$;l&E)!j!|B(_Vt%ujUrgr1>$3^e(VuHE2dmsC zMrV~8c%VF30EA>KcMA1xG@O0?G=*JX{B}P4cyry%`tvYBpsR5tIV%W%>Js4)h$kL8 z1QmWz^zncjP$Up!z)q=D*eb8CsuJ1@KP&7(B=2#%ve*o+%z>TzOdp zYWrOo$n^!L%=Y=`y5&Fz>Ja~@}uuwQp)N)qxuvin7+3!g$mOe8aP1rf^F@QN| zla{wKTUeH1LcXnkm8wF>yYI*H(S>@*Py;$znDeLA9|zXd@4Q50J$PGGeXVGC)H&EFzBY zF3vQ6Eru-{j6H6V54xlw(42rUjT@6 z5`ZYuaV&^6<#=E)W%wg7G-yR89h#cKNVQZCV-b+D1#;LrdFZ zOWR|A3vQA7L@);NEKUn<#e&-~s9)033c`3eRG3^gXFVbYSObSvn3~?!1G&AzY=G&9 z(e?Geo6-9Z^B#F9CF>D0JUl{=0Vsm}Rh}+LX}F_MqpSIcKI@ZO0_1NpRq#kZAk+Jy z687QveDwa~u*dCV&@a8&0mQ1?$Y3_rnv|J;?hyxb16M_ecUIO#E7Nw(>Z*#hf zR)0D+I^HVr!K{l`=!>(d1ihJO^+I8PbPkgE2Tp-J7S;Mdi`8+xnA)A4C;N_koI5k=xDoLNmfqVwj0(g z?f*j6jXVlvZe(+Ga%Ev{3T1AWUUw1)0x&g~F{}a;0yHs~AejLvf7M!BcigrSe)q3n zpGuvRWpF3x)DLkjrl($>aXt%0A3f8rNl{^2Z>m4I2a6O zz8MVg<<*<-Xms5@Bhht4qHo6M%d2N!zE&)vB*{odqpN+CWeH1pl#(nV0(y$*`#7)j z>aH($7aOisyl>jWe-{@UL9;lon)PZ{DdX$5EV|@klhQQ4x+yzHaL6xc z{QiQH*!Z5Zch6(fb>+4)?(4pBy;a^D&+ydwLCgh}@yC4UKb*@Z<8Sg4@X71$;)koh z!4x-?CsJf?8X!1!!;IB@##ALL1zJnfnr&HsgTi~#g>s|-e{O1^h3P4w;;RcyViZ{M zxT&i&1UbrZj5VycKW8h3%=!XUKFMn2&=05A~XdivV>-05bU-s zd-E5hzH0OTn4M)Gm<|Q);3E6aN~g7r;5-qME|qs|&EB**EK!0~XQp&{_3X!I$cjWX zN?D{ROVTupe|CpwwlB#t9toLfO{3OC`)B_=V=?=lTXH2~X<%(U51~XtsPw$nOcE`y ziH{Jgr8omC!9gJX2!U`yBuTZJIOux>Ir~_0oe+}#6qPI;HJvY>hKWfTDV73L&_ftxi&A$yh9UWlEmMdJ}>U-{7~+?f5kGcO+zFZNVVZ2;e!QSp-F~efVPn8? zN3=iHI~?0{Jaq$?vJTDDaRF;zX%u>9<_Ev55bzv70DgjaLEFxETD8ro7S;s6tu>7% z108FfJ$K-n(z%BzY;tfh09(SGWD619_;d2QiQ{aCkIU7 zf8fUxF*>0iedXT_2tDwB4DnJ)s>X;iW3!k9V9*#2`=CSsPIE34tj(c;5F&mt@|@-? zNJ0f59ZW*11?N;p637tjAmk;f)bL*ehFYRQK0f2cfE6fjM)jw_h|&V_auzTxDig?p zkYJM~5_Ew^mT523J1%5^*9N{KpnUj5e~3qj&&g7J&|X0Nk?O^`mJ0*P#-%Jm8ckBF zSMyt`35D?lUj=NCC5(&&EFc3aM*eIW(n$syKgYkI=h$QiqAxs@&rttugT*2TVG>p? z%Oc4@jYMM9{r(3M74Q-eBN2f4x0dt}X=M$BL{;<_f^Z-!9+`nza_R?lnds3Qe~eh= zlp5xxAsbc7=J7R@lPTU{|N{LjyAVU1R$PJ$<~fGU*AN*JZDsMs5;jR z&JwHuED-F_(*I-hn#spyLTQTHf1{a4g58G@y1*BbS#%-Uh%PLIE+k=)1j4GNu*@!J z55fkcqfTCgL&}60G`P`8AVWqBrc^x6*x_>x$@-u@LB_S1=d6ihXisxW5?qiB_GCD7 z*wj7Uj8-ztp>I*#)k>K3GyfXS5&n@Uoe}kDm=u4Tp z$CVbgsKL_Yj3qlqa-IQ^;EzFam4b(`hmc$V6HIIn$;FTru#om0=6Y>(0nuUO1sMwH zMDqJ1Bf3AXQJQGFUdRb5VE)!ICa5Swp2jpVlbGhE1MvJ|jHM6y*;gSi7Z3%e1xKS` zdRV3i60|JQOxaDK@?d^@e`8t`QWhs*irH92c{rA+C&v=?xnoHX^*~rPuZFre*>ADlPusoR7v;oAR5jP3p&(9Ee<^vpuy?gAMwl&?csSDi2Tj1asO{C9g#!Y!q?y(542mGjeTdLrM#L#Y= zBbG|P)> zQ_f$2?5C<9KM1%me{mIn;j2KsAzbp|i;_=B=b9x_s|S^ySrZ|{IP>y^!=la&)i=RK zO%eaeXV351FO%N~O?SZti%gQlU%N>k+Z?pMb7e1%wVeun4K+IM>s?}2?}E;9(wKeD z3x+_O`)}Vd#(m0b+HxorYS~Pz1ZGd~2%CwaXejurux^~qdmNSb9v=!zVO~o z6rM$MvL`%9e`RZ?ZBuWCh9g;wM6z7Un;8q+&$#`z!cBZmzN=3Nk|eGd&sMhmE(qk|KDd+pCNUmECWVzv3JVW zdndW{4eP1)kaufgy{w0m-K{_UH8tc4cpx*t%<80?rio1T;+Xe!Ys@78^7Y;8a!51Q zi5s71e-ZZ7TE=h7Ls{jmJFceg#2qF0(H-x)y*B`ZYgk}_??lYfH8?;#LPm$C z_2=68Zg*+{(_H_6aPwnsI%ZTG#vFt$5A0!XcmlKvIVtl13NI{xrdFk1pSJhTJ##c0 zpD*Rt?wBccVI|+Y@P<^i>oz~0AZ%~jA%%cfe;~8*!3PKqm@2w3?cZ$*b2N1UcfY0Oth+5736q*D;hI{W%=IEI>7c)&6UjQcK(s)YyN08Wibxx9)8}jCOX4jBl4G ze|AWgA0IfUb%%M+mljDiniFh_hsq&ywba>FflT5>fyg#6_$@l#JceRXprV9Du=O2Uakf zoTp0*`EyhE=41anVm;{1fj=^}_ zG?mHg;8>1uG1M!w&jEi{;{+#$rbxyx-0b(kF+A03kZ#wO$JwE^I!koe-sx) zyRc;nyc8xhcsTB{u;1PzxOVM)+#uto*diZxTR0FTaH#~}F5$qk@z25vx*Z6&4rMo9 zzB#;o3p?=IR1j7-oQv32@8FqN$x}B98wruip(QX_lmp>+pme}Fs(@7{d}#~7L8hZQ z06*Y`T=w?_aCef9zVfQfDeoe$1>_FC4zm`lyTmcMIXc?4oy9h zxnLxQGLW!kpyRrP!)>i)c5BCV;aNnmYCx_F+i@|@D-?a$ftisq|_R=XzAl4rM*fzTVa~5ZWm$4`I2L=TXNU7_Kl4* zP{qzq1zQd)CZ+@AaIh5ue-=*sZep#?+;>fNI(QH1T_LHT`^)1a@xwt<$@!k!--y$C zTq114s-gfN%EI`!&c(4YcX3BLD=2CmC@2Q@xr{@W#^^7w&1S#i!Nr0N7EUvb72BqD zr7}=PS-aY;jU34 z^5>4U@`XK!8N*FRM=&#j!u6E(g2U2m#lmcb_47mS+p{fXSO-YNlQa=)HMs5JhLdzu z1v%Sh&E>o|?3CRYt$a_75?1AZF&kM7%K&6x%M@*3Ln?;T<#btFfH?9$xn|+`mr-{T z6ag`pk#I+5K?Cv-^x^f4cg8b$j#j zZ6Pzknc+rcw|AN0S;-CKIehK2pI7gs)a!rU{`s<(8J%%fWq)qa-)Hf}kI$iab9?jt zMgTjWiOd)#O9iJYR;eo69d6uwUNBRcOcac3ll3;cyZPI54v$nT=c)-VnFMVk{k~sI zy|RxV*MhH({T@|?eMKe&Fw_$F<(jDym^ym9{lSj)oA>9Y{rhN71KH-;V!eD@Rx#8W>liO~vhiz*& z+om4uo+b~V&Hk~g56y0%!(#zul{3wYaD3whj10TU6Q*PW8ZAolCRF>i8%X? zYi{2&7bg_*5Fa#vxX6Cq6lJ-RRg_~e?{F>H8Wt-sTQd-^2e1`*@r(5)=ZYL#m2%}2 z|5P7Nt@TUI9c@6BB6+>A@>*EboX592IF=A7N`I-<7B{MVRnyN7w&dLVPlp`pmIx2W z*6z-DUyg8cY_~Wx2Uzmffz@W3zwerNoXcI^jjcaw4{E?w-C4ZaRX5V?U4J~#h_r*< zv)f6iu~Zezsw*ALntPwaL2K(hjm9JWHr+6i-5TquYm_4w{&bkwddKU!rn{#pbScLs z(0@dF!*_4t%b6BA`NL*D?)XBQ+N2bsW3=;togL6kgjs#p(d0;a!Dt6*?gd`A0Vk!Y zuyh{m-MRG}j(+VDarjw#ev9miQ(%*O8#dAJ$A<<(m;~@^r~r*l#}Sfp1} z^SJ8IgfB6uLs^LuqbhP%O+~f!BqGY4tgNQ8_tTVJOJ+*$30#t51ytv$ju4&DQIXZm z7&!hyiCU$^%9&JCy8e{n1yU7xpdc-U)~i3@Pd?)t*8$0yQd7MXsX|*aq2+}!Pk+h> zl@>6J7Ex|)Q*uJZR3efyVPYs~mrHos#03!r-$nuIR63vIX3&niGy#joIa5WoD?QVVGs>ybYHWBVgQU7kA-?+`L_Axx+I<@BC<-b@_KwQ@k2p_IWh`67Gg}6Thf+WCGdb zMj#L=Re6yF=Vr_Qq@Pr-zACwhLdz*~8M@1K;d!}gpxbp_o`gohyBtjOls<+t$tNW6 zHBnv(;W&Mrl11V;CkcfC<*xV z0Czx$zm5~)CDb7N&-uDs-L5MLQd(O^EuKSZtr`523UJy!(h`OnjSwIX*3$CRjS`%g zZj@Z$3VgIkd8AeV)AFZ^^3u4QuqW=C-OU3J z1>uGVzdYc(mmR#yiE1_1I&iG_;YD!C4KgBmsE~@4vW!iP4>+x5o`QP5jRbh*5!kmL z=K7a87|oh`4P^=v`mBF`zwoo*=*_-4*lzI8Ot>?yO8WXmYoOh`x}){2^%#3fy<{}3 zpj0n3)k}QfXgUwQArOsPsCnPoB=AT4s-6HMaZRt7C?~ABZI8QulhK1TU~Z@RDSeue zEEiMK-5uKxb)P&a$6-EiTFConM=XrX7ZAXtDn3xrbrVI%1D}5lf7}2r!}9b?r!%$` zB|{`0S^K*V`k8u<&QQpUNr0hQI)O<#K>=~xh2`l*k(#IA{C$J)&r^GsG2Ug&(q({T zum}%E+xl}Gzk?zL2{2OJ6m)0FSG=fYb8$;=@a_%HJ0yS71%#?tdC5c1@wiGv9_Q0s zh({jYz?UZ#hADp|<5oF!go;|~UhSw`RJK} z`FM)Fqa{j0VsdfSxb-HxDmelS2U1IH?l*M)Z0J~YkO@tSp$x@ zH$H6kz)^FiiRjU*hiB)I|DLZ%N@{6j&v<4NAU14D)kRhnS&xsU=lhQz#OAtv#y8g+ zzIi*1EW$|tH`kl#<>T9DzdaN5vJsm^ZsIg!K@e{8@|mTvEDJUPXK@^F8ohtHdiM8m zMa*JZglSlCe4eit*y)Qk!#HGIL|<6-!Fnbv2<5b9>UDj@a#4^n&XaGk{pJ4I^EV(1 zn9Vb>*Rbu?jquRi+}jD`*r`<&4pV4 zW5A*?bF=C1dcOu&U-Z|nwIhTcYznIF?qzuZw=uBQ0eOci(bPQK@ zQ>t-dWUcoH;M@m)aVU@(u!M!P9RLwigqwV0x}(?Ts2!Qgp62*CF}x!TGK{g_ux=ohFH_$!t+>tqX(}AzlLT!i??2DJPC4S zI582eo)HVJZzhaq={SEc8h8+ALRv;X-!3dUV+vOl_p6^zWSE8Bng$t#@g3@laeQWf zmLaIl72tkOGE*Ri0s`j6Ovu>H-0wuXHK!MA3gfiKSbC{jbI>^4fLvC0ovE(rMNo7R zt<vFd~glSzLt%=iw=r>XOHlH)@B zRMd^?OkFt*>nrzTU!9J-XnWh5TouKwBNjDjdgI(Q;DSY|n4i&T3R%xXw;YeWP!OOt z?IKin@06h$bGefc>9qhm1wh0)IHsd1 z3a^f;{KQk;wq}1PwwKm45URe^4cY1#P1Sbl(iEmMy0s~3#glX8L-|s>Q59|No=(Wo z*a@ds)#-z0yme!v$?DuW1`&|hPR01v`Bjt~uFct6LlWt9<2U;|N9x;gzGl~}fe@fZ zh-mcFqiV{!GWjP(8?@p-sOmB5j%T+@D@b-izMk7-maKneb~Ymp;}83J$q&Pjg>f)1 z&tb$;xZASo`|%DG3DcAXh~Nbj`2uuELwclPZK=6B!%|@Yh0+HoL?a}KwaDox%# z47~&x6OVsh_D3HoS9RgD$>_E9i4uUXi3d%fqtZjI^bdJm5&gO!a+X`GS+Ef}xta9W z2M<5i7Z{d@OfEg^@v+D!TQt_q9gJ^QQ(eV^z0)LF!8 z?f8F8XJISwDo)9e(#0U~vaV4}t5sQ!aVF}uzEVK^3puNXCCGPtL>~3k)v657wGh(g zjj^d<)qog)OpF%11HO=%KwYFAI1t3)Vu045BUuEB@=HcAyKl9pFC74+MPdL&`SAdx zv?Z-B2VPspF}_sIq0e*UmFOHY@+!{EQU!new#n3c9>e%4vc< z1FM&=+{T0gIV72fN276P#vwqnFbkm>O$!9>k=n_zFE+y{`-`L^FkwbI65^mEq49r5 zb3RH7Q-18JG5|i^Ui_3F;lc!?i0Qhi`x7~hOyGFfjIPv#Z|FA*T`|5o>XJa}E!D*D z)^Om@?|y!D7u+C(Y-+|HuqclI#|1&6#7i-DO++YwS>%7CAV>hMP{fZb2rEwYgqo0H z>Ga_xVZTd&l_%j2q8rsNV8tV<1@M1|-IT9ZivamA{(q?zxG~`}G+jgnn3kJzynH^O zg4~nb1D5ddd_Ga)xDZ*eZThORI8kJBk*Miss=1? zsq?uxG;h`bva{Ng%Kf8h9h1GQIsAfL?=+rSX_K~$?ez_brK}HzK&$l~kh_0n62-;f zJg!8@#FRz%j)$%;=iQ}5j*k9k$C1r@lq`wHM%U{#IWdcqrIf|>k4>?{sItoKyUN*w z6ub-hc)!JY(#@HyJ3k%T?Op7GW#4vAx&;y#hx?UPD)xZJ^=VvpC%~>H!7MugJ~b2q@%FP( ztAHV5N%k#xL9kS0XD%iYUV9hB$@Zq94o%m&B#>-Byno}Q<2Z`mHrRiN?1MfALQ{oL z67lxRrnbBrdTI0c0SAkM_`E;6w#|SuL2yqXhBCY-5X0!3<8Uq{v8~8SSKsQz=`3^| zo%}Crnz)wgQ$s1rMti>v(E8*3-kndb8chvQ=WI#Lf*@H0;juQ9dS%K9i>(+GqQE54 z(*q^qV=g@q7A{R?Lp^^TItr=q4LbOv?N)$bTZzOnONGAiSPhE9_cdj~G@T|`T#OZt z6Ihbv*T->ZZ++GKE3(K{2x-Yz<4Y850O{(tiN=YYz99QFjs)0W+78 z&Jh*?HvZoc>K>g%l^C0>8jG%%-grB8pl?(^O>ym-{DU5&j`cSUP< zx}=5guYY*>GaM;5YSZGmIJkd*1%wqZ5jOz%;SKJ|yjGtpQ{){{D4Nr0sA1mo3H`Bc zhQpCoKS=3Ux)ayiAW+`J(eSRkZS(qI*Q)6J3NsS5%7?l* zn)(1+;*5VKj%N%d($fYOT3Y!aBdOq@qNzo}FJbPked!H#S?LMe2#w6fsYL={2j@A2 ze>XcCn3^asPEieAuiG!KqsZeUejN0mM^?LMSU*jSG%fAN6aAO`?T4y*wtA3r4Vb#r zXAS?X+S1r-hq|ND#C)g{q6E-RpYxVXlSart!}oudgEVF(!r+2o+-DiSR!CM^nyL5q zno;xe5lxkYiyfG9vtN)KIv#*s^u(bv25d2%+miQdvgWAcIP?rk3+An8`ejqm>8({( z01jBAmmP-IIXqw$Zud^p7x*a&pF{@`xEu{G{0C;pW`i#DWIFu@IfF2aFT*hK1ECV& z*YbbKyYIeY)LF!W^0GK}sI}H5pVBv%`~}`AuZP@OeH$c^P(exxiD+}D!RA5e+pYM` z=~J3L>SGTfURw<1b$x3siOW`89O%3_(ug@`(?(!}Zz%RO{(rnykp}@3O79IuLP$o% zjn=3*Afw{w!h>;&M#V40Jda8ZqLm{%27G_2W;t|wVkC4Q{2tBWxLtFGvu;5Upj4o~ zf)vxvdFaVsVcP1h8CsxS={o~W=ht;xyBDFP+e^v&thotSg!9iUj88EH@7Q5Z>i@?xLM#f&BFscWU; zyQ3+NGk4yqj4hr&;;_VSzEwNT@1l4T_81 z5vY`ez$K6ps$DgF5~c%()ingO+0c$i#kh8<;#pzj%s|NwYEP^4l1AJOMDBE&6o9}E z5qrDm1*-K28$D1K&v}33UF10yv0I~>yWXPfn^rRere08YDw(#grq(1~SXi#YY&Mquk~TPc}&?0CQ(5F3A3hGXxkHGQu+aMAtuE*dq;`Z32obG1GyI3f-r$94hS z04Mj_2Gp+zoC=kynZPc(;9zzpIpep^PrAG%YKgj}2BK#oRg2Wn3_axaHNN3+Il7-< zw#6D{po=3{)`5dndVz@jbmpB)LXilgQBmzR6p}?ZF(VlILXM}3(Wrk*EpAnq3TQ4C zy<2!|uWlps*R+n8?&^$Xsc{;gp;ac5gaa1J-O$z?D)xpH zrcmGeC#~H&#Y$qsr=x!%l-P0AFl_X+kn%RdPEBbLuFD(bE-$E3!b)v(!4sh$kym9e z1fi?TAr@`S_4X8fIyWu!BdAQv0Gno|mQoV_%^@KFPkkSC+r8fR--1KY<#noD*w|3z z%GjR~ge|V}N}6!S%PuataKo@&k?*>q3|e>IyJKplt~8ffxYK{_scno$+f4=C?SgcA zFw`qid{SGvWcSH9DOTGp=X@)w_9a*&bK0AE!AyI8BGNQiSS?Ow3I_c~%7^5dfFJPD z@2DEwuF*t$OlSXfsComaTWZCs|KLY+VVUO%TZC9-=kMEHP8T_V%#0#tuN6|DW8r^% z)EFoC@2}oHT>XD|rTC#E@i)-IiagHfEmYYL>Ih{L?h^T!ti%-iwcNEpn{2Ly3XZm$VCBU5t;lp zrLI1E%|br~@gY-$5_QARUUOH8r1XBG%Yfas2n@_o7UzHTeCo@!*x`gnSRdCgFynlu z;eON;k_1WBdKf-^1GrP4W6_nAa;0!ts-{FIN31}MNH)Au7M6qNeyoLv+^iOg7j3h} zy`lDdyKgGERo+-VY#plTKlYy>wQN)^LHGlK?C=ltc?WlO zGrS7RC>ulU*AJfs-7L>5=|dfb`~VgSok#oym8yTA>EWa;r#h`LLVatONCe~C*bB$C zx_LEQP{z_ZPf7&QNd36_;s)G~UB$aP-&LQs_e$lV0y;lA&csC4tQN+=4@IohJcho6 zzFB|lZ&zEI1f&_Sg)doH7G6T1k^fUs=yN{_`AD)2x?8Qq8FXc16SZraO6T?JS%f${ z>MMV}&q0NYb5;dQd=bjAjcE4!)iW4taR~lAVZ&`z04RCENZ9?H-~yBb96JBSv(qO{ zKWifhG~E-Zmz{crzv_peLAFRpRFmY${7+QxBmj2QumOTQFjs)0yHw0F{}a; z0x~(5VY3n`f7M#wlccs0e!stB-aK1%BO?hAa+M$AA7?u$Cztakez5((fM$m}2FAd6 zcki!Hw^{PCso3y{ z=}7a<^&BDwnI`mfVmrjt#?f3l5jbT^x@PUe?DjN;Am=oG#&{i;IzT{{&ppj zt+~Iw;?cJ4N<1peOE;W@z(nA@IAKzOP&>Xe=ejELf1S&GFt0lE>%}z1J!$CKoBQ;Y z%7UFqf5n85evPBsMQ||*i{r$P__oDu-(KxR0^2?erlIDss_UMbd1t86AE8-NdvAtY z;|IH=^t9SyN18LGxnHkxI|}r8!7R9Sl2E~Z z@%6@ZtGgf(!6v>kebH6tp=z7eRZ}qObUf#Ghc#V*feA61)#*|X)wworf;(B91!l;2 zypsMgsgtp`&6*r)`Y|uBc2e{0a0G!nna11Jo(tP@+nb@M)^Ie`XfCHcXv((RgBv!O zf3q8xgE6{aZ;w@Rq^8LWYt*1dP-h12ZuOZ2J_XkS%MV>;de>~}*_pg_J-7>Ow9xAO zucWe1==J9)61C|WES!k#KN{+F!W*!E^7Oa(Fy(v>wflQG&FLk+sBJY+XXSRZH~kRq z?b4fY1*aanNqh02=)icKve5K~V?I!;e`veT^yjuI{ZFlPV>h5SdGDGzJx*0~8H|Sj zdft*Z)J{fqGAsaZux1OkJ0Te7`hN`ZDX2li(?fieFdnCW1jMIYGp^F#1@Yf~^*d2L z(JbNd^FjRwGkCM`&{UdcsL(pCNkPw{?fjUk4`6&1#ieGc(odtfNCeYb{b^9Ve+PtU zZk`X-ha9kVvCQf!O0YPR3oGz3qO>vMj$VI`lBjL!d-vlZ@XL9;E!xxR(tw!3-N~b@YQp;oqSl#iJ6SDr(=!=_xq5Dli`Hy>4*bEGX8-9N5q*oU}*V(gKY{p*vjbv z+5?J3?S(r)54l4i&4&XF0FmDQe|R*Fi#!>@%{=mur^zXZ&>L|lXw>ui8<#TA~xTedXhCW8XV~*k8_9W z<~Y>%tMTO?w%oN%_0CzCjp|c;{|(^~oq%4$u%FkK4+vTk`%81MUIXUhe@0?xl0F#A zDFT0Tl_cAKWC^CL3b(}MJu)Tr^h4ea=*G4OgB(8JnXbhxv$bM zhon*oKDqq3ID6YwgL#d1e~{OZNtv%3)7{*^s=%jyXF8Q~#wY&$XyhGZ^J}oxwgg+L z3DYI*jhfD$B=}_mp=W<30KL5(NJrFW!(M;?iW-NmJrVQ>9y6Wl(4LM8?VI3k#95I2%`PFT;-P zJrVyjM^f8XNNhwiOo%BH;lvJbo2i0K%wbb`_7PTVyPnX?tDEg4?=IG;Wn5@`ES< zz&^U$-`ioGR?CQqi6M?>0mN}FTSdU*l99rJeLg`f3Fxz`)p_1^c5u3P2ngO zb|Q6gunS=@i$lf36r>HrAesuMnwM)DO<~(&L`i2BxPaJJmI*-vO~w)i+iN?4`n0Yi zr-w6x2VN^QgrL#2iEmlqkBB1*bvDId+)%O)5gw_#;@S4bplgV1J7Y_YlY4NJ=^}); z*x6Q*D`Voge{kTk#j;AkU)(d`AWCfD4q2wBL?7}?ASE#aNbu}qAz?OM+R+lS=XjJ5 zLv|DK#7SDpU~tDs58$yTDcp<~6${u-_Kf}DalpBz`Pn1ecrX>@vnWy@p^gXCYobt@ z#O6kV`DC70rYyPI@d&{B+q^?`D;%*vTQHC?=T$TGf5Fu)%`vuV99RK3tE-z_TTIKc z?Qs&CsqMbXdmC8rCtwf9wsh_M-i>hcFvq2qg~<$~61Z;Renv09v!>}rSx81fE%yHA z7Eyq>{s>6+HDE$h)R%JH1Z6Z`l{YqdL`er{$0;Dxg1h`M7()rVRxY!G#`RT(IRZJ) z;D7%9e=A0fAJM@oK&Xb^P2(Kxp59MYQ=O`Jxepx5<_|9^2enm1T&%7shw15^vR6GF z&@Vfe=42Rl16zp`j=EgQj)1!smpVt%DkDtE>U`8KcAQ&8s>*sgyw3NJ@BO8tG_SCw z(^!e^cMbhSKoP}+b{2#N>af5)AMs^dySwPAf8zuMqqbNCxICFrupu`T^Rtz6oq#I( zx@S>9T0yrytB}I#l`o39?E%GnOFgAQD{HD5wOa&E`<=-eKG%*8{+k9O-ppztkUa5O zNQ|7cg%=4qM#Q@{F_?9uF7cBJKUrB` zZAV29m5PY3o~KnHR9x~hcT{qsl46H}Ta#`VTi*v33A2MCWpT0P>^#!6G#(CNSP;SZsLsjmcf z2)A`GUGD>^0xVv9;jMN{d+DmJJ@szm_!b}kV2wi}Bs(Bt@mmQ-og z(w0J7*Y?Z-nzjU7mlR*|LnB$C_PW8*6wNTrn?;qxJ0G7af5ZKGs{DW@o-hL|ePyP{ zMBay-stGFnP2238wUiIT&C;;V_ywmh{_8-4(}!j0&|0^0wL_1?tJZBPf0|TkqCopG zKMX4vAaV^C!!kmq(pfpe3a0b}8uYybTLoMrF(`b?hqd*1lmeQ|j{xF_#1zBKY!nta zfDla?nNs6!!MNHr4^IFI^%y&PxNg7wy*m`;ba*;+iz70@1ntLkV5XL{z;Cr_ZiXYZ ztq^LiVL8_klK?6!Xda$#e;3OHI5&QO!*BQLgue8N+9tO1nyL#@-OYv?Z!DP)D|}dP z93kkoDu?5f5UYvn+&i-XXP&o_xhR%>*12G2UP&y9q(|z4R8J}U` zNL(rtaTitc)7jE~!MXo36LE)u(6AWTyUrQ>j`PnT9xF2?b?)!i?harcTueL(YM_H; zswUKxzwcHR-Ku!vM9LP8XQN!X zYq{Powk5$u_3Q1rNHwK4o`3mzn}{L#{PmL8W7f5D6%cE zZPmuB$|37LP&1H*WzKL+ax808`S1CF2KX3JT1A%a>k>^YrwJP_;q=)E!(q|;>q&R)CYgt zbhqwHFW1GMnlCLqkFDKM*Hzt6Q)|1f++R~`w+)2oUWeCpy>Gi>-w{O_Mm+8=8(USy zsx5YhDh!Y;?Y_0UGqJp^!oQp2zI}PN(js4$SJdPt`R(Gb5O5_FOLR^`G`8)UqVy9< zxm??QXPcHjipGZ4ZQa^Ey?a)qz;l1y*d53Naed{6|K^nuW4%evnamVs^|Rds8o4km zH{6pLXf|D}BvV2W)kmV5S|DLsFGfV?m{#+kJIoJ3j#bbpJ~t)gDlg9@Umm*>$~@t6 zGPY0{UF4C=+4=G6_zWbyYIb$o#i6^Xqx!J&x?ZUyV`;9ZD(}i&QB@8sS}%X=Gm$Jm zxF6e8#o=H#>}-|fYWaFk1ege&*Fgj{+-$9%Tqi+zv>o>w{QZ`s$M;oZ?aJioS2aZ|#413bXBsTY7QJEd0Z*GyfWB_ST~9JdV(9>8(8!Yv?Kv zz2#gwRr!x@i`6>=WF-X40N7^%vdYIuW`q?D8l5K?K(a)n)c3u&{%yT?4kQuFdT;4v zQ)2D4(2rXO#sny!1I{LpUeU9l2P|LNFv_-QcJ;no)7PN}aJ$ke+S7kmZ5`jLUgP7D z;FmT<6UN$DuRm`q*CIy~d$~l)a+OX2v~x>!)yoiVJaR@;gBA2R?n^gWv~qBl?lrp0 zmvgogNy;*%upBuPDro&5L@AOnWyW~Y+xRU{_#B`$lS&Z5d9%eewq{8FrB1hP9VB~V&Ue$oArem zGl`Q}Wn%$f{CM%={R^i*z7Pw=6*JIw$~DWSUaWU7e*KLvHt2*y!6HZ(H=cComPC@^ zty=u@;_q|eH;$F$nwhw6xLuHw&4v zBo)zAQqExm2@8}Cmat$R1rRe~9IaEx%X~4S!ZPIZv*!6@*G3qM&p=1zK!kn_bR;O# zDRfR8w>B)3=@frD_qlH~=f0;F06;iT7ZR4pbZ-JRBPvv{+<0jsCV)LzOIoosb2yWL zxEWlJ5`Gm@Y*3PAIUJY(Is_Q0KPZ)z?S_>SId{(eol(ocu)% z&Noo{6vvGfJUqowg#5wC-Uf$BPm{W#G zppLYUkE4GqBF&foVvPNJj&WE_=w64HRlR<9PFT6wmg_CeN68#s5Xig2?J?X3K?2-f z)iD+EDX!}aNvg|^Zrp3#Y+4`v`)wSQgY}YV6;i68owrgZ6FRU8_E@&?FU|F0+VJKv z6chIqHj9{%rN{{3y>_l>(Vteua=G0_+ zoeXvq7!X0*d2{E4qe1pqYe8?1=H*U!hM-)>5nF2`z{jcK0PUbC%s?-1{D>2%83*=c z%;Uslrwm99J167B?XoOd!b%c7mVYU#+qR552-|JzO&i_p2sk2#*xV)aDfkdy7&to1 z5j1~v1P)q7is%bgkhVN0a5Q3KmSj%@&bqEX6ixf7*h%2GhC!bVJNksp2jQdr>+``! zy6gaH7swFXzc_qSWUQu#k3fpVk?1)1QW39<2}HlRgLV7K zQ7y;N*=Gk*VD>>U8F>F(JRg`8M{JYkE5$aIrA#K`3&b{+3x5XjBrvs|J^a%)^$&kV zSNyNXwlS|?Ew(A4zZ8;O1XJ*cIm~qmBQOGRJr9gD%d>o;QY@DzqR5|b|2bX+{GP&K_@0`V(?-a$B0FJ;3}ulrsJvDxBhXbMtFTCi&160Xt=IO@75?_spXE3M zyYrm(<(!<3yWSxm>K04b0fR09}Sy#_L148Nz!!Y-;INyO_le)?m+IxU`y?PQiaW4=2rY z7w2=A1MZr)N7%c$aWj}#kA@vC&;85j%nJgHZ_d!^mVkrdF`~_UMmVC9TC0-h03Hr(o1b$EhNxgWl=6upHg6wf-NVFGKF|c;#0MR27Y&b-=Fc z-xYMq7(Std@qBK92TrbB!gEu*TAS8fV#>de4I4)JSy9)t}8bR-Afq5}u*$bq9H60|lnbTyHY0sSDh*?IKf zV^mQvbN8c=YHE|+U0&nc9~TqHw?E&{tof?0!+|^a#v~DPjwbV-ZH~#W{*t95&-vf8k$-686QWXdzZbO?1Rtek)nr`^bdb-gXE)bgJdkqSSgW4 zUjR|U&5jH=J2F&tc@5O`gl|RE?(9S_%11ylDOyA6$y7~u%ev^g3|p+s=u;;-u7k<6 z2fnZWai8(d1nouJ9(N)5Qis2R%5)@AgI~}Szo3F&a3w>u-iN`x7RF<&j|~B^qrikd z@?ayHQF+o#HIaWSRwA!6_!n}=b0Hi+9P-$UZTRPh=#BAC)Av5iEDN`UDtdSE5xMB8 zI}Cq)H&>@2uzr#OuHW5*!_htAjOU}`AjR@@TD&l(fnE%YTk4N<(`4{?0;6O}EJJg` zL@}$I;x-6!Xk6Uh(8mqAp|MKnf5-(~90|9AE|Rn{_eg(S7B(&ViZ_Mq!Cm5tHtLfq zrZ2Op69#*O;h+h5vH(lZdf!HSIsyO1)e|>$vBL7xwsY8qBuW1G?c8g3P!P+kMi;|( zi>^leolfempw&naYqxZADDw(Ad6!lt(hF*Z)or+RpYvkkl>V6dD)c59eLJ)l~A&kg{YFn0F=qW!sqivWGVLDPbu2D zvw`mm+RRYOne&hyfm<&Qc_q1Y#Un18sE1DCjfp)9=jW^Tjb6 z>$-s%4)uO>PZXSh%s3tqP$}ul{B&q@+hO!$+;hruLp%Jdnl0E6+SfjfQsj^LXOi;e zZFv4ZoU@#`4~}KrC-ay=(_9^JT>0$+_@cBpr(NWfY0?pB{Be(OpncK0tAmL2?4=uZ zk0gKer;2g3`$cu79#Twp1Mhi|@x3??+pRoBo_Dg}dM_QBN|*1|eY#LC?&c@DNV6rj z8=K}B)R7uehkJI^Kd1wZMQE$LqOWU4GsbWmY_vG+rHbmh2Kosu(7g4v&FDDTrmQ#R z8jjtDDZE0_)!t(32t(O63Qht{TT~+UWBD=j-4}DXkq9X3a*5@V9n2A1pUv zk-HLJNxW{jk$;)SszL(~O10&dnzlt`5qCnuSbGh>#Ne2hgV}Fqctx z5)_xgrVA!JdX=$c3D!yi2}-T_wVTbF3qF*`tjX=?*9h!f5m#fP;sgZtmbBZ za<>|@xj(0vd~3Di#C&`kxThVfAqHFx$YE!(A$O&06%EQ zk70LF&|$)~roPn6>h#G_|HR8WTLB6U0U;2_jr8SzZ8diNBTYc=8_UeQm0=Qb=b3`v zxAnk#0UujhsE6{BT>uEV24t zy6HyiILV}6Lm3q(sphqA7m0I)kNC5-RLG8BN=aZSe}4u;AP@w*v=GY*`8ybS^0AhA zoFv&VQOWyaFbJkK*pGol1(}bDb)4Sq(Alt~J9)ifQN(Obs|lDg|ycP!!yhonmm#!c(+Md^O!E8Oc3bXJQgjsk$PW{YJNk2n< znf4UXQ{&QG;O|Z8xP~aJq>jFMur3wxhN2J)JNQ!emWD}?BTwntv2Les8bBDMBbQeM zWvi6V!cTqkIsMkWP3c!?;C#k<$yYSIjs`Syf4G(vKh^{DQucif8*D@~2vVV2@6vn+ z77*)1(F}+II&^$6KXkX9d+5)*knq)WW&}Z_C}IK5uECBHh=|@x1YisemapS1T|D)} zo4?z0(nQ1%`(Y>8Q8Ik_J8IBAzD1|$`r{JUQ*<-o>|Dokj?`n>pY8Y=AG%Y_vw3>? ze=5swTv-Y2SAN(^6FOE(`59k3uXPT}88KNboL(1e#7XR8AX?cUhxyBazXe$^27o*R z?H#fw64+hje)pRB3v>$JFJhzFX*A9J4D8+hIDWj9BvlqmJww9TTep_xse!?MQdRak zvbno-h{8dR9X0`I0Vz54n>p9m5B6I2f92={UsDgPIzkj{AhFK4xWy)yv_-(==XR+2 z+J(DKu1p@AVzwxXDH5aZ3Sr4ib5KK;rrzPf4Sl8}iH(^Lsag#4Nw^k}jb>%M1zUS+PozPTlnUNa~xYydYV+yz}Srr>EoQ!mO=$Ugv{vB-@lkH;C$Cj zy=H(9(qc9;H_feocno%K>eiObOpRh7RO8Ge9UxJmj;iFUZ8zFClesP`8+1->rF}1e=LnnwjpSFwwsdXDi(VFz@-;t!!i#JxC^Sn;I-}A zpKQ;x*;1S^`67hR`1njK%IF&CMgSTtATg{X48YcllQNN{7f7do%&XpxmZ*c10(VOV zB=KS7y6uS)K=azD|KYgvSZ5|YZVI01P3fCRKg*UCn&M`J2me(|)eut=e|rDmbb)eM zKo2bGr8}~87w`#Jxxn**Y17~};tm48EpeV#qcO2bZtB&mi=%KfPz7(##{48pe~ z1%ZJkk`)?%fZBl@s^&);AydQxg5LjmIY432ltlfygzBHbDU5|-01lA>7OxASX`ag8 zFK{i{0%~Mk{p6fR3Lk}Te@`8%uR=X5Xkv6#O9ru3jWL=$EN5+GUK=@bjpOI3pV`T{ z@?1`g>G5EN_@M)XzbiQ35(X(#s)E2qXz*^l({9<2aSf5RH*Ls~I6T6x_< z#l5wl0U)E*dzBJs8PR^4M)!9)zyjhHViE=&dRd}uE(x;F(kin19MjXG259Em54oCw zdCq;V{HE1J6-W+P)7&_zi}8hFJfDHDx*ieguc}>}2uG<0W-tse;lY1El^0RDnPs>k zuo)5&(ij;wG5~l@f6iC!@tdyyZqu&PEY7mot6-;>UBB5VfqFPmH|x8W-tkq}SDXD3 z2Q;0Ap*4ar3P9<`7(8DIeQYigl&vivp0P!X#{e6SdrqXKMufAH0iKk*rStr}adyq=SP zxMwO1C|10`!Vw0`#XR)M-=W0OzrMn`c0+yBByiSF3HogN->iZ`Bsd=h_MU|Tya8%% zpu$4vMU-z7oh;oCcuR>6aj_jRo>F%OleN-w{WI{S2VSN1N39s>Dvr9iCm%UH_V)X! z?zz#iXBGpof2g$_77R%7?Hm|d*VAU*-GLXB#+jAD23KG4CmR_BP@Wdv>n+w* z6TXM20tgt^Hshww;ylyuY(+eQs&ZY)Y{%lgf@o}RDi2!O#p2IcxNRVT9dEPBn$pPV zlhf!9%XnC1@>QpS-a{2+;3Prc8fF}D=kztF8_0!YJ)1gao2Mr2a!}0yX|UsPlb70! z5a#T94rLpKg;Y>)&dK>|=P*|y=V!rWV{f3pGF{GxP6K;{3_`uhedeR~UQxGS{T_zR~7cVRjSv3Hmf3y3j7eW2-wfJBSm zJth7YUB5%uH5M@Wvoqfbdrvp}YzmbDNLyrViJ#M3V5zAbzyFR#yyUoQ1?D1f~ zGFAQ(MlcTH%O1g(G-7E9N-XehHNVQdGFurm-d}UKGUIL~{JsT;7@fq1u8fgL3}j^Q zcWLBJ9!YHS?s@K0nqv7T=tUS9p(YFt%^C;ld~?NP+txrV^hJkJNTyIz zw)E?-7on^tl>+Uux`JHK@uv%YJaiK;MF$8Eb3Ak#K>no8 zva5KB01p79%FdG;q>|LoC(>f1a!;P;!_EmN&s z*x2|t48@hH{m%W1B<0=#QkipiO#ojW0d-d+UDRS9lCM~W4+yRk$)O?q*9iPnTn;40=Wz(1ETvG?ghmFml6X45(F_eH!_!zN)ZzRI5wAY!vZRQSxb}KxDme3 zuh5ZlEEo?yU6q5^>)F~QPC3q0C!R-t7>A6D$nm;l!qO0%__x67VmqEys9;0s6E=hgl1#|6&7==( zw-0o2wVsak3JeWjqtBo82mfgGJFQPBUPdtZvHHhahGVlk1J(oCj~) zwcx?0s@bnMGU9<*i!{((Z}O_?yO-;Yg5lw~rT)6kiLA?yry3`J{c`iCad}uAs0cRn_ioaKH44r^Pu;mhuj?7rYh*mjN5T@^M>g2x@)Ox>)9Ui zX0J>7s2o{Yb%oKrBkB5lukm29kRwTds7B_UcFo-FuF)Gj=4vBimZ=#26$6pl1C`ZL zH(k{>c@3gUBP%L@5|c{fNlbREtBymR_dreGxF%AawAr=hs7toqBqAm$*$HRU%2HD9dO$E zI*tOkE0sil!S!HZ8L%0n;XE=)FSjWZ0H#1$zj1Gy9d^qA_ly5I{hf?1HQs20w}tce zrYdR78Xh+AO6{DXZ;x;-Agub%vD@}ws(KCUIa)U`bk1E|o(Kg5-QYapbLRoZ#-kL7 zEfLsf-|kI*bfhys6A6}zk#t+-9XY9wJmQ_U+?|&-`xQ0bfB$r~`e2D-Ciu*Y0SlNY z7}u~(LjZq|;C-3UTb&{TMDFfD%fBh`l4GY7_Q^2xYZRWR1vC?0x z@ts;5XUmss3I#h$V$ZX3tIkBVktt{VLeXBg;01r{UoLrqFkvbhd5+j%iM1o0v3^w) z`qby!+G*$~ybcI62m%&_k|`DozgW{Yo5ot;evJk`izLVlowpqZ(JgI=xXt$Squ%91 z-Ct~GfAQpiB}1kdr)ki59f8i)%^Gzib?yl0ZVy#)n9a>56h|Z@0JOXuPtdW#ErqeW&w<+dCb!{p zH*7(U6l%hJ5&#{BZ|sC+E908E#japk^zC7Wf9@C_G@yM25hab zngKj4BT2o|gxw($P&-yYRAOx|>eL&vDZ=oWQNh$yzY@FK&XxNT(%Y|)$LG^qm0>8KvRmb{+t+BmV{W@c z%WthWD4hR3cQap_$GWI^kJU0TnsQp3e`cR~L-@35lSNlHrNx#WFYE%BK{y8Q0!jv!@tu$v0H&2vlBIl9YysMs$=?~4 z;oW7h5-6Ye7F2eP7yWvsEnkhygaBBYJsq08_CaV4v>(vC-lc~KEGS`!e1U@ye}@Zy zi})>z0We38<2MD6gJ<(P$p0vQJGEVPAGDRasE&F4bino*G=)youlNsJ_mC3uU!O)> zOcA@AgMnf&Mw1fVOL|2Jsq85K-KEl9E)8y7iBVH;tGcEotn&aIb8PY0boP>l?yCoO zl6pXEQV+|Z91OWnOQZ>n$w)F0f6BR(CV+rN2^j(yQ4wg62y8kVMPrc%%&s1M3K=?2 z8F|f)Ce03KnoadG>@BOJr}`E4+5!XgK2S#hT*Q`a`OR;qw$aOC6+C947*WD0H;|L} z1o1)tvxEtuEirYysBUx(j@rU9=(MoCf-~$J(T&*)0MhmB2CLr{hsT0I?eB9sabE2}R6A zD(B@AQmrfu{QuDD-B4582DHo;!Ax5Y_W1B=69V`*`dov3-&78!sq~-I-^sLlAnE2- z4+F=%X+SoSt(t|QMBKk9e+~uSE&URN7%?uVoY!p&(kCyJlnHr(-l@zOj`>;bm_Dg|7`vJ`7+>$^Qkv#CVs0{K@E6Ay5~6SP1=^6Y zILl_*;3A8dnPJ34G+LC-ZDn#X^hwUb388zhPebp9op;9GW=w*t;lPZY(QZ_u3Sl_{xnL}vduDJie;c8VBM@);3cF41$msCc zGE+6ml+;C!C~AJ?uIAAcZs8o1`L3%vj7aDOQjS%cdhzy}79S(R1h86D*4DLzsg1MP zN$v<5uV)WKKmpb_)YfYy?v>8YbL8iq3OeNycnq2Il|zHlF-Yw(isiF46Hs)w94`?6Gd-m#(g z1aRsQ(xdPEiUFxf3ZwtcY?&T0U_C@Y-(Esx92;>f5O_;kD}^+`7+dB+Ey zvCLA5Lg;dD5KjRMXOHL0Awnvp{x2Rpd}{2gOup$0Pu|b~V&}actjRyD{dPaV1QaKTXz(xb;{`%{N zp5OfZlUVKBXMD9^@zo#u=O1pKJ%1I&E5TXHQ?a_)tlAg0FwG@@&7m`uokF;qz$xc`TXc3WU241>=6uWR8s=wGoOLorX!;yeUpy zQCC5-9DfugEKPNg{Kj_e)kc|k-5o47?3FO8dRQR*HznPRY!s|zmjYw z9`u7PiX=;9Jl(5$2SZc6?uw&jSDRR?^^Kbb`oc8OELwVcg$k!=3e7yPn{83;y_A}s z89nm)d@B1NPg#>4ZD*UM9hIqOJnfIWT;5Wp#Ar*k;_D_WXxIALjo&Anu|{?8mS+U> z)QPzK484CT#bP3anW&fXzMm#$Y0TXK%@Qz_jbtJblcfnWl_QK?jYj=`X*O7~WYUP~ z5x(zLpH7Qj!6FsYD84jp#6+B|Mx%bWv{TR&@$6(Ki==~5EH&w5Hy=y}ySW(+d&do5 zTBl}G$=R+(3%fc}TzEOje0lMBdG9!1oY1XMJT-sg1skftrqpysBbH1Hm#D_@z`;-t zwy{g3j9uATSnLWhH$|zz4CarFXHDdl&|aZBgQbNEzANSY_q1k zr?*{GAF(CCN?Zp5CqBhBKGU@=U|9|Iwa2>d4)AGY@Bk$WZ|LiyT8i6JzyavqfV!;N z+wQODz03- z|Flhwb`NX}_XEd{$q)7H8=IkpdhuZ(QZmKp1oPD3L}Y3$4BK@LGb zZtcldTU+H84M)Wu0brD^+H>Q42&I1=vMxxoqyq6Gd{(tr2^MoMfgp8WEAo-~lIWC; zhPj)-|0b;tV!?a)RBbVb1!YlMEHi zPf4-n)Lg&J)KJgzK!?T5kkC5<%&n32zL{sh{?xb_R|s2`qHmEI&}Mi?{*t zGaoP<;R$3s5DL;eKPjttL> zJ=INTw@YsUta=^lb9a9_caMQp^j`)mok$je-2||L1cEF5TY!~L;Mn3X!>Wg5=_`;b zfpnhB%Yo|6!1G2>MJjDhHCU8~tX=KlEC&*?CmLybcIAEu>}mnCq~?GX<_XM76pQCh z{TpCb5dAfvRRY@Udd^3M&gB(Ao_S)rS09rtI zfZ`SibIxg@ud5*}Qc?qNo*bndyFQ$eFH(2y zr|nabg-lMVh#46_n#w`5x06x2>A+FLo``wv&NEVj*j$!j*Xc>M#EJcG3(v$G8{m@i zr73cS=LA<^HIRR`FcS}$!qOCgCSr-uJ)+D+jJ{VioF_~{M(bs0U^*NNDDKC(5C{j@ z#K(fDnL0s~)+~|Y0)=ov0(h1lBqX0uAC5-d4aU}em#RGhFlKq_Rs zR~x}O2RJxFkm=#44?Z4k-%ouqTY@ZS>3zH$pZUW=QJQ}Um1J&1rZ<+7pT|&gjpzv`>7dBJ_c*Y8tb=b77DN;Ebnuf1u-%RbLS&uyi{^J> zFR&8m?reNm1`+?Tc~>{y@X!y+#dIr$GmWFinTvlP^Z!6xZtJ?VS#>$__`;jYdbfM> zrqW!TxAEbY;Pq~4a%e`;tlIj*WARe?Q3I&;z*#qoB0(FN_Jmc*(8McfeP;0eNLeoM|oeDb!rvldGb4Kj%zqqCR zx~P9D=Udo?t~VNkg*+$IY377FhULGe9&qr^`k&Dm@w0x8v76!h;AZn$;HP37nB;Kw zIk+*n@C`_P)e!r(Xl0z%=pLUc)#{pWfs2YDqBbX8pisKoTJvDT9QPgJ&{)Cn=&v3SC z0+{&b%!MbAk>}-k8^*XI1@sbAaUH&*(qtv9Stn+FL*|E|8_W;B$jXv#jQwx!LK$%w z259cf1yupwMLH(FSPqAscb~5F!tn!iV@7iH&<{O7{rCzSzQil2G7XQmvs5p^-+q65 zNu7CC=EH%&4`?)Zcy3GN2(o=7vll~xVsh|YchoQgCJ<;O?#@T}J0D*ZMy(ta;4Mu!nu7PNRcZ^eF4Qy0hoN5RI^bJVtH%K*R+VrUg@Gq5Ilxhf$ zm!aY-QjO2wk*6~aAvuftL?iZz#-D#eP$u%4h0Jo2J+v344?yIAQuG&|OQ9x(d@!E# zfwwRzn4tz&{1;>F-^&5VxW7V#=w7(%38~0{;hC3pYu)7#yfikjF6r+oqz7wk9EK&s z+aLQUBso|3CoIG8qa}5ZZ0#K;1ieOppWtf>OKCwe&9- z0gSz8b!B}QMmy_S`XfRL!L4T@KnkAML4LLPhY-!gP`W#xPESn$&OiDK3H<>e)&m>C z(@9+A7VFcr%&_XaLxI(8Z2BC4sL3X#_1ze@T4`tHiSqy2Nv5U%u=XFUy}U7(QFjs) z0y#F9kxCI00yi_4VY3n`f8|&AE5-Q+0UcS+6JTK#d7?sVXBFyAr?*E2?OpON`LKOq){D@zuqH(rFN=dlj z-Js7?)8s_wax@JCAvv4yL_ zmgFKo@XtK-y$S+?e^E5Cng;n4F|ZgRiQ>^L42PZkbawLF2`Y< zgmZ=X%{!k0&9VsyxOU#*iKa;T598oXxXo2!#$^k7AcHaR3*2xHFOgG~D zsX4HD(?o;Jf1m{IP1HM4Z=!v<=ZxYC88iSLB8pB==Q+*IElV&ASWez2fbjxEQ?090 zu4dPr4DfO^AE(5ibM&LZ6!NxpQ?{=>v#&foK%A?C=ecD8H#CTv;@--0a7@ed`*}rz zdy3=mie%v8-+)(ar-!HK712e|1T?pB%l)baZlPS*<~P5Snp?78uV2On1*yI^i2xKAy-KS>F>0{9W8IC&S&uUD>iQvzbLA@qUl zbBKr_ng-EE!;9^5QZQ7Ts5u}Ge}u(TUUR=&lXXf+G(bt-Az84w1bg}YRDwEB@TVOwxs7IEuPcE8)UF1Jky%M44V zv(44IE$7P;HX2P?ZHqM;j6{p+)Du04&$%YlM*jLY>^xpgqSFv*RcGFIg%U8^$%L)i zf9=-A!o?>KS!{g7B{;9UV9FY>7(S3E(m+mbXirw_3Q+z5mp&m3&;z#O&=*tFVeZ0i zO!i~7ZQ5enPEBe#(Oe%ssrR|tBm|YSypL`@ee5k+dzRau?=B(dlHx;jk{GIcRCS;T zzY$aWU(GSd_g`I9>rcfb9|=XIlEXM~e_piW=a!t#1sL*dRe1+jx7axBaqBo_>2@`6 zLhF_!c)OuMbRvcO*|fyC`RiG>+bMtWJTM`*7BKNZM1#-lZNCGlLgS)ZM_w(rm!YfL zwctCA_k@0n5Al{0j%gm}gqr9vzwnS!4iy1{enKFqVxzvy(vEkBj7U-&YyCb~e^Coj zUt?y2{g88W@Lr%@4arCCvJ1#%4)}IbuSofT;_@KBf%GCS?w_a@*Bf;(4uk0w_dbCk zuG99m*tn>)gC&{3T~2%4HLeGc2YHExiAM4%PgE0pAvE6k8S_0vK;A!=F)`Q;s)OuG zs&Ujq5cSxIoQ;iQ{iW%sc;nhtf35{{L%X6G*6eEOHc3$uQ~BkR$iRyc0aqH;)G%zzJc<_wcK_lG^j3M;Txl z)1imq)=6nkI_$WlBXa@!H})|6R9Efps{Lu}>dP;W1rhj*9LVDMAR5bhe~goZHrKpN5)zQBC*(J{@!)aJ=?6otJLOFG$fJswMf zLS%ytmyc}hnXx3WWX+!=f3OLYLkN8!mYUY>{^#oIb>MJ14SEDFBPRSLKLrHlxS^I!QuE*Kis!5@h?!CtaO*IrR5fsf( zX-q|6U}u{5OjJ(Qw&q+)BEX}Q`ofP`#Q5C4nyl?;7(ZPWNoS4&f0K!SSS;MG#mZk; z$EUE4tH}R1NL`RY{`b3L;pUCo6*ZPeqF&0TO;xsZi*i%+C6835FkvFnYu7C5($_I2 zWyrB`&iAEAI?KfgV@h&t3dO5bSzYE>=ObBJ?b( zZ6GkuAJAXBrmc%|f7^!l9(v;?p=m>@HoWizgY)fn>(c8VM_2J=PlF@pdu1wDcp1Pb zqq!#3qc||Gxv8Gp?pBaJVgsU-x$@;EA)lMrxHi6y_VmQY0Y*kXjMw_2>F8K428pl(PZcT@_t4e)&3rPqKCT(f1aG^omW^T52tQHo}STU zU^KDMXfkCq85yl#lGtN385vEE8BHdPCUg6Z8BO?YCitl}9vlxDg_t1J;Q{dtavH*+(cfNX z32LA>lnS8XLogBt-m4IKyq|z?CXS}#m%2mWI1of@L&Sxb%kp9#!ev}jqK6AtJCAJ5 zgC?;lddN5Zo6rxK-{6_K*0UetyX&%DP2UK>`&jHQGo`GGO*7nCfXPktG59cE^C?k{ zUW=NKf1MJZyozAhGQhB0cEkKVovpu8;&lM%BGlN#x6bjpiRc^}8qIH4(ReYzOI~)8 zEGAbC>3|vz&92L3JIOcP5gdU%ByZ8W^X0<1m`|T?Fpic^eRRz5b zH64-lQ*hf;N6fC2Abc;m>O4&6W|%4-T7|a1PXWIWfW_pkF$hso_F{aTjvSN^f^seqy0&v@m^@y@>Sa-b zEQ?jKy>#))7}jkup&aYm14EjAvC@Xc0)K?{LPxUzr*tpEK<^0989o6Wm#*5lw)VLR zKRj-nzsDs_Oq2HQ1@e=8NQw@+$YUXR4&n8-3qqJK^RJsXxy3|ooF-e?$lz53OH6lz z#pKB-$btS3+36I4mytgb6aqOim$BFpC=DSr#81N;t36KR0+Yd<$BamffSBN7e8cpH=`|&wNsmGEfje0e0jbV(c zyQ|qnR@JFf?2cNa3yzC8VHZ`SD+RwLxkwOF5XZsJRCZFL3E~o&ZdI3)nvh%#)r9O~ zka7hHx5V1iae+D5P#9A(f13n7jTpH-ORJsQJPd#AQ0<0je=s;CjFdUsRotI59+4t0 z)Y9$&=TXe^3SwnvCM{QyC z3-s_@TXS4Z(uONeOSC1!1^8Lk9)W9`6fFRnL@se=JVV*xyxj}sl$udmT*_@i@Ng<@ z=MqLK%|QvH)YzV@e~^+HpV(#mH3_jrZIN-9Ip~!HoZ_~|i6B)oFGrWP8IM`zRNAe@ zeR9&uZI7D5Eq1_>nunuq%gl1h#NZ#_Z~@{k=k$E=+A%oD< zpFdnZd-kxZvd>tlhn0~qT&jnMcl3V$W%a|`)p#|%z8<}M^E%>ZGInwF^0|x8@b7AL zvzV{k^|c$_f54prx3nQ|u+&QT2Z%_d*7^WZlVa`;5IqRD%>jZBXs|gzOvY{iETJu< z9oREpFBg-y)0KPgMz3GpxY4`mmzBG>`Q88iHN}PTPt&W>OISCZuWk)V+Wl9fH`Ck2 z-EuO$U87Jt_v7@_Z2V&J#k~(WVHP1rKj1;*CGG~cf3d6;pU>wDjP`yFq-IY8(v6^< zkUAlELg|Fsgl~*(!(NTv-hEuP<3G*j|F{~xSS&wHm(8T`Vf2U5A4e~70G$6|vzTE1 zEY%}^w325-wnW}Q1NiBS+5fzG=B*q3uz0s{@cM5iv(?o9I9|@?)6bu06r%ptmUIwn zviOF6e^Gr=q)+y0z(?v?_2SluRxiO26pIrKfbAF6FJf^*x_~{g9o+jWS0AkCX!HS) z&o%mL1qV*cr5?0r`tQ5(YPOjB2OAL{q%@%4h&WSz$%s z2<*_9e6r#~#RD`?u1p!u6sf_hF%kq#282aHe`29R;8zbP)a~6z`;WWL8cf8?wmAm0 z#)rNFt(Cg$QF!(dc}H;r-zdkPB==Ni^#ovgSQ$Ldi*W-cMBu5R30?tJGydZRtl(j7 zz%~r9gg>nqv-(ni=y_c ze?=+QZ)=e;=T=^fIBx{n2$4HM9#?sG6NM1N5$JB=DIh$QLqj!iKa`++$(#l0^2XFq zb`j3t@=|;@N*k)Ll1`d3Ad(3(E981_iU=aS^tNP3AfxCR?SwF@ppjP=z=*NI1}B#^ zMPmRPNse;@>|t?u%@fcy`gA_1cG>w5f2e+U`nrQ3M_~r}ktyyY%h~urbss+{pN}8Z z;Rkj2K^=Zjhaa2eXif5fK*DHGDjG&~XrOE0usNghqWJ_T$s*^3$7914Ig4gNDt^&M zD@X8HknE6ss>kDXV@>h{5;e0Sqh%0Eo()$(*s^h2gS?!NGqo4v<)^#J1Vk;Ae*t-8 zB(Nh;SUkR3gG)x(3~}+B`O@Y{28~5$OCfm>Qg{qBR!Ul8ByEI$U9>!7WNgTHoyS~4G-Em*#go2fGKjo;H=%F2jgUVdIZBCw# z%R9X8C`cdQR@i~!9V#~j6!QTpf5(rYa+HSLATXL1Z0ilc5m5dqNz33I5u7Z?qw;39 zK(B{BkN1L-ziZ*$skPf~Jm&4QJtws9ISJ=`j_Z(hF^UoCicT~m*{oRt_S(ieh}|(R zIaz%E&v^OEe`lXoKkvCsVoxmDR@@{pBjZDiJ(ZF1LDLCkQuVffP7(m(f2W4FZV|0{ zDXE8|L~nb>Pq&eIyvN*X9*2P+Jpe!Y2>6lBMy0(mSPR;5L+!YscHB@qZm0wImg?=L zf$hH7COz5CS#EDXJeR`+Y&!YfI{H7(#<#Q*Ttxob(f$GNOcx)<5bXHst+Mwc3HsofQy1Iv$DOv zW50ecSI~N=C-D#$1h64t=b-?PCB3LE8i22WY_|FVn>2zf8+VV@i=Nzz;J8;nH1#YX z+loXL31dj9hu=c&4r_0r(DxyfPAW$9MupQrFu(gE>d3pNp4)=of0Tw}8X_fY{qOMS(?)H>k|~ zK%4w(I{yil*WpZ|e;j>5bVMMcz04;x?%99^kcEu@b*8kC&wVL&-e=9(_Et*ir<~wA zBvU_S!Te&0J(W?yh|&pV!)Z89iauE`pPjztK>C(Pq;DQHSp{V}*ykt;eq|qXu}5S$ z_`4K6ovOMQlcjG=mP5g?W}3Z}ZNDp!^iz%^U_?F5u!IDwe;g{*j_xP*+|3_i?_vFg z$Zil;IX?)?=F=1V_Glw?Ri$)QrF0!#?K-;Jb##@!OaB(oG})(oUH@jg*nys?fg^8U z;C*f2f-e`g<-UPK4%(K-eS46R3`$Saz(sI?__cupofDxaY2eVXsIAI<1IJz~Jy8Q^ zZ?oy%LtHbuOqWaBf~*0FHo6wt`-BL{l=W9Sz1sc1{XAa&b1|PyhBGQMxRRpPA#WdD z5=cu?``poX{0^Gb+3?HX7r;3{;O%NWUv(D!AHlc8pqHT=6BGh4IhR4^5)_xF&Jik? z(7+J{f7`ebzR$1VQL3`AcoM|sr#9E2elGKi;^5@fy2Ptwm z^4Rlm_9B5G&}ejj=m(nLUBCY)OSbJ5O|}V5{(A5K&(~Mq{h0EEQDUfJ$@L~NG||)$ zD&c9J{Cn|{bG7`>_1}iM#HfUlEOCuyn~Xc&e?Ml#yX&jpt{9M`2}_J2TnkuLkW6Gr zakz5*DkDa!gr$TklQcHjT>a}Yi;uRZ&$q@XCmeP=+TY)oTrKR~?UK<&-K=q|FfUCQ z1A>a7J#1eLH4pq_63EE6xpJoI^vAG<#(&ry5vSy4SLX!JuoRS@x_tPBV~d z`jtBF@@8whAM2*D&!%NALD(j)&|14(F{2l2`;k&!m0ej^zNg-}rM%o=3Ez0{NRB|D z8R1!af#-`bU=)O&sW|;3Rdkm(hq@{Yf6qr_+pfvWs%zmL8_`NuLKz}V#L#P-id1nT z^#Gz&5(9vK2^cBepOI%k(HDbAXJbvI~t3GUS^@ zU<;M+wH$2@?9}ZuZ`RQe?aI*l9pC2rllAM5S>#j$tYqY%3_Om6yAm1f7Ur$MfAlG7 z0<(41*-!qUO`$F|5vqrJ#3`D*c6Na;q|`X`=^K&IiMx1RwGAV z9ATAi$rk0o65L#}3fplaP<~H8fr%5T@oQnD$Xgq`@@`J^8swRVYI6@KZI6)RNla|IU90g!~7C7;=~1}9O4}@e})VyM=%)< zAGT(}AmA|$DA%^?$^u~NXV#H|^^Kx#z_K6fYVDAMQy-uSw5nn9j0|}Oanyj=-hIr- z4h|$ud%M)TmOlY~nJ#KX>TTINF$o&i14AJo`ZE)u6v3)N(6nfaon4>y;mONDEb`-V zU)uG#1Vog8SZr;5uw8?Ge-0lHHm`ikOIr-G>by97Z-hTtt|X}P!_LNO)&9Pm z9~xEPfRlDN2{6vwe-JzkClsFoPJECNdg7~1Pv<};;U>fjEW>D%gId)qN1KXfgt8$q zl?)zVB-&J<7!HB#6T;1(PlsPRdu*SYuNWYmjj|OV@tkKXL2Hl9Rs zF>F3hK@KkGDUjtbuD?;9A~R0J*_FmiCA%`yV8x!E?7sU1e{q5RVfPe7ZpxJpa9zOu;EW$@;we?Nsic#r`nJBZW}UZh_Q83}3_#1iHqUueCv3 z!)*4gY>=QN73tu;AkD~L#tI2VGGU(Vz4EPn2KX={lzwUW^!#2%&opZOBJ{vPS8&k3 zk@2Bm$syvJf5tv9V0@?{8T-nswtarMS?9lmQ1kyh_8Bw#8nMr}K#tHEWLUCC4unFP zdXaLD$OO?we;sn_Q+GUdZ;Rq|IPLS!u0PbxuTQo<0y2gnT5%8(+)N;ZJ&%VF_zuP| za(y`hVi{rL0V9N*GL|c0&jh~&J11L zlzHo0n2Fv4d)E)4sLQ$Q4D1!!z%3j--iEfmWok9q!EvU{(}Zo60nq!#>SN`kjqfgKqdjd)`8OiIFa2`Hzy@S zA<*q9m7OQF_Nr)u$pd9!e1Cp177OpNlksI~e=0Alg-tKagj9=DwJ(=_DF+O0>Mz&f z-(NDqS=-vmHtyaYdR=8?Mt|VY30FM}WVup8gC0+9Sn1}@Q-d8kguyPun+I<3(ZU(3 zE}f!rOd^RqI|9y(AjkgFz4fcRd&*&RX*4e3Rv$b}Y9_b(V~dkzi?;R`$*wdMTH$Va ze_et@DudPoZbK<6^L3~=av$D~{F{IUy8tYJ_)B=-c#A zkoVZamd6&h`qKo2B+;6UO!c8&mz!x7V#Y*_iwvQF5rQ87ImDT*7=7sA9zFC%v(KP6 z=b+J6_pxzc_T8uaaE!qQoAuEue@h6=EX^~5!VzE^??PCl zDpQCOK(3zpge>#XGYhebZ_g1Oa~f$v*dW2peg&@zlRv7zL;|y4Wsb}VTBNwfWzYC8 z=Zwlqfl2zWJ0u|jIX@zm`y>H}9PVx(szZC%5J=(qnH$vCo5MK3Hk})HR!DZ^P%0Pc z^`BmNvVQb~5hADlGIgauUnb<8nI6pnO#Tl{M{nepp&Jtv0Wp`s-vJZ>Fqbj!5h{PJ zSxb-HHWI$iuh3BqxM{vc1<1i`WP@GoVK+N)fH*#A)SPa?YN;)$-JS&d-&15!&(YXD zv&H~Js#q)*i(fs+etrAPzge_zZ)miSX!P^g5(TaM-|VCDDa-QWCYkO+UXNUC5O2psxzdBRU$$dpSr+x(i9<=eVy zyR7OqTSaN?ST-MS{~2v@KD2@;nc}4XxuIbtSSFb+vt^){Qqh)klB5Qw{Pce%JDy6r z*>Xi={(}<$^Z0b0(nPuqd;UY#9P6scal&Q8XbeiW_<3J9*y;R0jUS&kT*X;aWOtTRBJ>1QYC$+3qNUzJ>U~S=*5f-PJrX z!()8z+Uk1GUbc^552qoguP0R*P4$kpkMP;)P2b&Euv2D91 zE2^$tM(0_Sl_WI`VslEQ3^H#IHpJtZ%dnK_bO^{LF1Hf5g(6a^p6{cJ$ace2{D8r^ z*`ba*`#Yt)>O*q~$mM@z7pJ)hz+HHlqnVODgB$IAk}bh%ly?$@!XUDdAj3 zTL&mU(=RdeUGgLy^`mrMRyrQxm*Mmhk|q?BE)gJh%ZTnP0xy4O?&<@6$SkjfH3J)H7(ehlEW!XK~?i&Cbp>7|S z4Mp2m6;RteV1IvKxH9Cka{yZ*=`IX)hef%u3Z+yKY1jfwiI`PNg!19&R{=S5$!8gN zZZSAbh)EN!qHAq=zv`e{2K635a?2TEjD-ZW=2{XCUSH#({F@#spW~s)cd)AbmQ@q9 zD*uXAS;`5AcroGgD3og`oEY==;1DNL5qA$K>v}w{?~#9US7c#q;5pdF0$Ky(v2HsY zIJfrxTn6R}N86%1XI%lnMEb=|#%{J|3JzOPW;nzF(SC-j&qWgFc5U<8ox~7Wdu4aF zEgHKcn{6UY{3cML)Cs$En?cJ6S8Iwz-O>!n?-hVRE5NC1d7Nj?2{nuFEE4)Ow8PK3 z>f12xuNHsWnX3tux9?D>?5`6*vsoT`u=B1d?lzppXJmsSMj6+gwgYyT+9a|J{HF!{}`+#vD6V0A8|xm+8ltBN}Dz1o0e$HW?1|bsrSVqx0fW5wyror?LPqT5$wt z6-Y^aXqq1*hscx+r?@Me(R2IT>XQSo(jm!A9}rM}pPND@gm-KBg9|J0Lxv)JR&0kn z z>Sq{kpa9om`e<_f`^z6|5n*)mC*%ZF6GFc6`th|PSQKnb`$x?_h<$a%*_+TG&wQj= zzAr)KwoN;KB)aa2cJ&beVnPz`Om8Zzv9?0Uu|kBt55swewT&bAup@j*a?KFQg_uQh zf%(w2K9oUgt3KMf51$%NwkeLVt1N%4=7VE+#y}a>Y&E!QolCFGtFU?ZDxhZ;4`o`S zeb$5~WF@ydo~XF0tF8TXF3RGrDb7da36B*Y@vA%dx)FMo>zRHC8MUaC@qx9Fweh110&QIsS3F~4=T}zCv!hwI(6KWFZ zVeti>P_jbr?K^A{O&dvLSKkT_MSs!r9Bozw2@mx-(9Z4#;d&n{v?zXIHMm?g55!5? z17BkS6ZSY&aS#+V^ZojMZKKF4{bnFW#RR|bhU9v^26Co>Odwl6Aoxh2CSg` z3!drUFpQZoL1z351Yn55m!TUI6qm6a5)}e9F_$2j0V$V%<`N2j&?7YyBe)VkX8MqA zk~ZzOlg6Izbdr5QDA-~{ky?_n{TzHdZtz%hs_K6@a2M551?;IT9<@v`CWOmt{ z;MwI2&;D}j`_uW!%XcZA5sWm}WOjZr(|9JaMwr9jV)iNdOsSavdj7YeEz)9!k(&8L zeL0(Ee7sMMx92B+znu^ehi7D_HKLM1uM8=sX4&e*Zd|->m2hmv9 zy+}$GB8omDl9Zci28k3=_0$F|b?is!EhMFg3G%o|VgwOb!3QDfqN+3d=c;U4Q?}oY zB&qI3(lYivWh}&bkBqa-6gDoZ*CQmeP8C2*Nx2h_$vlX|g(BJ8s!IfD~L3(&OZO88$mls&z+4ydx;=iY0j)3j9RFcab|Dxyl!Qf4Txdb`9-|oACc7e#2lO(X0VyZbh

Y-_S*NL@L#Or6KA06C5yu9tbX43ohanANS_;|9fl zI88|SIMv;EVJ|$qVTK$Lz)Y}IBuy1c+ofqk3I-h##SP>Xxg=P2F)ehFx@w+R<6>fHf@yJad(li>FKzTj;x58TXa{(9Tf$*FWOx2SM-vOQ*ZDYwV*@76S#YNz z{>09Lz$tk0yg#)tL_n=0oOT8H0g}lFo?5IUf#yIj0qmO)`ggsA-u}LKKBy;uE?CWh zGVwrS(QO#C+wPKp2dIZ}++oqFLhKJ<&zrT$>}g}y#_`0Wo0q1YZg6*Y3w+ge;eI?3 z{EjCe?rozP9y3tm2E$e0M9QUi)T_&C(}euCir+w1_c%xpqF~+lPW;_{994q>`ReA? zdRy6}-0R?H2~-R$0vStFuc|VC&%$31EoYLkPF@#q$k<#ihejjwOM{a!S>Qz#X1%Q9 zvY6gJL|VEj%_`5l{f%tqMTW|C#KqEfsnTX(I7}UDv{Ak{7aeIvinK*>+Ou9)4cud* zdiOZ`A|n->pOb=6mr(m#%EBeIj$l>gyL?6>3MEVH95rR6L36QCO9!8JXb>7bqILO9QZAwiLl>=qv#0Y*UNQl^K%=%1U_S!>rnIw4J!{Z2v}kTW@4{DAD^ zPBSz;KK(EXqtpk}&)aY7spym%A>A{b8NOdRjFeOuwZ08$!htshE4R6=X=Oe935KoolK%@=TzItmR@g%Q{M zVDn`z?IXa4ATX!LhEK2We)QaWxA8sbft~KcaL>a&l*3UFvnM!=Q312`&};U>tiCMF zS+=x`O<{j<=Vz+y(>OoRe}Ejy5F;pS@)el zKtk6r%RC*HA1omA*H(o0i@zme)Smh3?tL0nz5mQp?)|VJYg-6Xf7~VAXP2m{I-Mxa zk)q@t3b_Hn8DG*tg1SSITa5)%2xIw>DY=FI0mX{BB$vHj_duS1F2H$r_p?nycyjZ!?{$FNEB))l z8VnVj(-vXWnuUSr?ui9txb^iqKzei|CPd;^kK^Qh84AOC`Nm;wAg^B=_cQ?W?im7< zbhF^4_Oqblf7l_nAG_1xW=p9-ktT9u7}t~{;s_n8ch>(;rj5o;W348n@1I{bN>XwHHlrfK?j_y^3uO9 z^0@%1Cij<`o%pEof9Av)&P^y-nQ(Q6xAsKQcpPdlS_{=Wq$2M0Xk)*KCFW~KLF0NW zyU0x$(&3VCRM>-8_siCVUuU@9x!LPukKQE3R-3R}b&{7`630s!N^0|8;G?RZzI6=V z1b3%>ja26~DLttK#_s=ixJz)Cp&Jtv0W_B|tO67PGm~)!Du2yd$#Uez5xw&(`Upmd z5NgAs2p`6>BrjowJVBo%AJ9Ot8x|Vq0np-5U+>JyENleD5r;F@rBQojW##fRtG~Q` z`-9jW`m1Pn*hRbV#_ykRufF^?mOBxJS(J(0?cFYsyCllONJFjM{TTcdMY6VET;Iqn z3i76eLMnsdXnz|j<>zz#fJG7H)KXWC%{waZtGuVueKj2Y+7SX{h!;vUkNyBwCfH#D!l#f zYWJfX6^E%C;JLxgc*rN_MY|iJLZdU{O&pp>3nXe}34auiwzE`ne1Px0t?LkH0ppW7 z<3*%GnHgBft$ll}c!vK1Gk7Wb{BkYeM(V1hYG0i$b&kiTdV9yC8>Z!)cSBXcn2sk5 zFuI4Pyru@*^!8c=r+w{dZptMIZ371b+JOyB?SdaUZf&BVJrC8X`qdL-kjz8dfdrhW zdTEBLrhg*cH56D>pmg*FkdJE}(Lrs8zXw|~?-oKUjSAyPc;1D}Te*?Sxb7P%Lm|Cj zOS!x~SPr-!raM=FdtWxZ{g4sg++Mw7!4bPG3xR37*yu18>8?0kVS6etQ-98DR$E^EMv4^po-G~a*DWmie)wwQ&f+M_ zjEm;=esftKwOI8{QP}e^k zqB*~Ci%lwNiv^K?aft1V`n*Y1tivddClrKdkud_js&jNfh3*8)#%Za2cd6=X-+xt? z6AhTia$4!y?vGV*R5@|6~ju}Uu(>FTEovK~k5dDcMF#cX;sPVayPws#kYL#Au$ zdGl{_Jp5uOs#ZNs$*Ee}qB;Q}#D62L(5~NCW;&=)9x}uHfrg^(I@_PyrX=3ErkSk3 z*v<}@uIZ^Wr%w;y6Z&Ceh%i(X`*tvrYD+n!)&M)xxru%cGfgIg2lrLMuig+pG5`XM z@hDlagQmR(5XagML?j&y4mi+vMzrz7Vf;ZQl7(VuSq5NGr~v^j_|`gIp?{;9cs_@Y zEluiO%Q)z%^QSUQMkDqv!Xpb6yc514eL+3N1z16W&fkb@gP% zh>6Os9UR7Y0R*i9df7k=NS%^d@VC3g_@(uT9nhy}0+c69S4Q$|yQ(d#0(`#<0%2my zO5Z=6!0UFVLMk&T2sgB>BLaI<)-t3Juaaba~bA(78#e{8|t}R;6XL zW59yApci}cx^Tf3*$G;9LuJNL7)<3EVp#}#@_HSekhca$0Zugi%osr@D6qm~1ffM3 z3Hd27rcNUl9J~l5T+Ss(*0;{eHO0e6f(1}gm3}x@xb+b#IEH+ILw_ljb+l~*1Vms; zJOdCQJXFGbN`PQK9v{5nQ-i`-G++nYy_&~QLuuk=-h({T7tB<#2r?7!v&s+uerv@f z%*FxeS7H?m*CKfAe;27hiHWx=sUMY*R+-J-R@60Hn{{sHJbVL5dW03Z_2bVR_{LnERN z8uB}5=UkCK#W8OV+=~e`{K63nZt_Vw+66uC=B>cR>r}6<1uV?!T1J8T(-V4U#x*3m zFuXpgM@Bf-=?HLlykZ@5M<-KW%iSON*3ME#L7<;NQtGcUaerwm{8qr3Q3ReoszBQ* zKgmfG%04=3rn?7P;1-LYF{y|>w!vgr8XO*|lN1KdQI?h`lMJR_1`{tSgi?eAQ@pY` zc-q`SP92=ue%RDK4Kh2KgsqduVH}%hPd<*2Te~cH^Q3}{g@z~Sojd!4!4OKXs9vrI zMJ=X4t|vCIQ-6PiK_Q@vM%Uyt<*n18t;4PpQUVP@CW3!c2Gnok3SQ~7o-3VJln~`+ zPKcU-Wx$qv{&5+~N3fO2(l8Ur!VS3WYL+f?=NU;6eq9n5zN;iIw4A%Pu;2u(AILK) zF+H0)I*D#J+xbfz#EZ?d(NJGzqoDz_(U^)3w}92(+<%UOiH7g#+;+q;tnw2Bl*mM5 z2`xI8j_su`sq6wk_+APrS}#HS1la?io<f1{a57A+-q2e78!1l%(pV&{#GCh^EM|$4}XX>WR?X#ba~;l3A{#Zf=%HP5rkb+ z+U)x$Ory+3rqI)jNPv153qfh%yn_^R&|d&z_Wj+Zb`N0C>qHN}eRXImOy$D)2j2;o z-BHvfFx8U#6`io)jSPujyjAi_?Sa0c2KO)SFK@~Ik zf;i9luJ>n#irCT-Lf(`w_S!5I?6oOW@{gUAotRCYnW>GiQJN%7bn@F_qe>tS(rV$^ z|9ENTH>@}xmR9G9Wvl!FN# zE~TY@$Ml%tClmla8RnQASa&FGhIaDH(mzNSIHQBjHQ?-G8D# z7Yf2Sih7*Ox>3r9(PH@r2PHIT@v+ANP;A<=$_Til$dQLbs)6P>kPr27=VNs^a?|rW z-ZP%CJj1yk>|nmst$Rb*fP3>qKe#cEATdem5F<7rN!T)8p-ZR6q)qWWgO9^oPO@$a zvWOx2$@FugtUf}NAHjuLaxLdmvVZme+5MA)Q{DJa80sZU>0eunVU)zRecu?1KgGEhk4Ffr-ELb95OY$2S2qaSE4ADaBcu*r207$bm_1ub5$ z7cbYsU?m0FyL7$fVRt;4s*@ZsI3rgBJ$vv3c!GhdL`CX_LS(c;8tii>;C}#u({IU@ z%Vx;L>vN*#j?~p1^2Ea4HxN>>C5l%ngTIpQ*$F9)PZVk7^?JS##1kcN+Hy-iVIipI zr}okeJdOU4q!$>S$RX5)<6Q=0<8&*&qyHTdpWA!xkx6>+P#|r$*FZau07;t8=G`=( z3*8Uh{XDJv1tY+++{^^TDSzNNHA#C{emi42nw^L7Wpt$`SRVDn|KTZTI!D=DqDPga zp^5eX2|o&mMWbx%{{-T7|4$$c{kQBz@DTyVKlAsW`TqnXc0A?pLD^3pHV!M)=yR>} zwk-g;g$g75=f*RS2`a+uxc;O6+u+Sp2yhc9cJ{@X@EHh|%-=%!<$nR<&i3qIH5CM= zGf#n?a7RPe);x5|(!$8o#YOpIm7;|@tsIXjTEQt=AMIk_n9PSpN(4>gn0x(Q%+GM7m*i9{sCKhAJNI)5-@i8S@jQt27pLFGvP(a4mv?dmL|4 z?~8G=6D(+{(3b40x*8sQ0}tTG>KkDo5=vL>nS+&u`;n30>=8v4rr!Hx(P9wzjsF25 z5UCTFp&Jtv0yQ?5!PE{D12{A`mm!$}D1Y4;$&TYh^xj|L8;&$7YV|V55sN?q0m_Zx z;KY^0!m&fyo}oeW@4Tv4<=Ad_Pnh9^)N0rA_Ihi+-2L(si%#7GjZP7bzJ2!l#{+{e zjaZcOC`kojSrQ#C5AKZQxrk&!GA1LVqvONRFX0OZp0bQkng$v&k%ThkX)TG6On=&? z{j88$h!aRjNixpv5XdUT2+QS-LiUUxPmq;BH9o;4;rnLy@Z~p28ZkgpibuO+lnJ|x zk}M-4PoiBJ{Te5P(an}oO5-1fy06OWqMNR2o1)%qxuWs8>iYI%ic7coZTJ019%%E3 zQIgY~S=y518H=`p69wjUq<3d+QGWn3nL@IhWP$?`2Q-rRpfjQhWKRO*Q5XGSG)R?* zxa#mbbh^Y<-{RNkLu*@KtB#Z(&>?>C&rLl64lMSH|=fuBzI^YcSn*ZR;`8?NGa z8>V7U@SQy{j4La>OeeNo&s=v>;lGhFxR%z z-7AFhM#D|jd+7=f+_X+BI@d=Zt%Z(YJ9HywaQLEiV9`~Vp)Tx85dZY)^ywGmzW%eg zTx*M(%b2}hb(RzYISt-|e18DAf4^bCeqmm?m|6?A?v3DUZJDFT6wSdCDVj1Y!uJ%U zIfS#lKR|o;+M^5|zL=E-g|cqd*ta}w(ILF(GmQsRcsI=zkgi*6&-a@|#o!K7N*7-4 za;As^+NHlR`j4S9&Oc$-pNk$>x^RvI0!`f*??UH`~c-8ZycpRDorh%=HS^V9IfjOQ-%7wg( z@&5|r#p^J$0CJFd>?6f_Ds1<`C~oHyUVh6%lR$^#h5B&vmVa}xUdD2gi17i<-wi5TKq{Ytg7V}M(gdqEg#WjoGL=I zMbQaajEZN~6qFu3GK*R%91tu z2}uBMdjmvc0DoDQtq~TI2(IoREQy4EWkUEhkj z0P$$zad3f8LqiC_$;9JcFg)j+Nd9sEQcsQEfzkV_u5s6BUHT_*P6ZO|J@095bY3Eq z0K4ULFS!)W;5-y-kAQNz3(<2jRq5;bwKzbb>u`r!Pk-yZufw=mwohf`S<{L2emNL{VSWU z&UCXh;b%HUbCPo(urRc|vrU_Vq3&-N*oZI>>!!G9gfVLk{QIi3(P8f?;VTW?yyb9! zoD#Z5>z46QB=;eN;Nk=3o;4Xi1Zq%UXrA4po_|_uH`c5dG!)Oteb%M1MfS7g&X=R^ z-7jNNc)2DT8lejhxX|=@p{9M|Y~b4B4+W4_5+W0^9J?}j-RH(Gk&Rhxhg};$Pr5cZ zNPX9nxxuf(nF2PhBBh~kfdd!|T=uHk!Na$Ww&^XK&Y^%|=L=6G;8vGwYrxSwL|OS6 z)PHEKwhq=6Zo7gaIWjHaRc^DG)n`7;Lcist5x%fxp`2&@_N?Pr0=K>{!V2qJHulk2 zYL}G>>JnkeSZcJ@^v`Qu9jd;5TrB~dWGWwj8@WkUc?qUdAxK#@7=m_qq`58NMgx{J zZO+#4ygJxDa_Am;GPjD?k>!5qVpEgD9)DCgn)ZS>Xf9a5b9&gx@HYc>uMtcRdkte} zS!&PAO)MN=eYIbOk}b!!DdY;tq>Wz*KI!7u?mw*AHB}G=<8My;x;^}keC?2kX6AHd zBoUB^*)oicnam>Wk)*&i$H)M}pt;+3e( z^UT={2i*A|JTm-Im!TUI6aqFmmyt>l69X_YF_$5k0VsdPSxax+MiRd3SMZh*km>Z3 z58oU+F^~k=jU((~<2_Kr)(jC2IUzYxgoXe6R&_O>L&@?;_CkQz)2yzpuJ_mc?&|$N zMX+ryc(4t4@NRfA15f;4Z-e2-`*#ig?wuDGHO(uRkvZU)f7xR`+)}tm>@6H_7VS z7S(^HG^;xzOl!aX*jT@|t?0R_%C@cwKS}!}gDJkbG-lOwr2E6MP20RGJ==1|tg(gN zv@>3}CgcPT7XG9h7c(4_lAVKWBG*3s&B>!;JAshk2SKq$W9 z4}vE6!%>7xpht|A?BCo}H8ELM9ljwI;Rt_Eh0n}>;9Qn|dv`7zY{5&veMAuL1(A;m zQXN}RDvb{*Xxz58_M)JEAK*XpRJW0uZzK(;jc~B9oD;w(&B!F>#yJDbENO#HxrrFE zgkjwH9Y08ECKN8kau!prb?Iz8@%||kKU|ISUXm~wsX)h|LM6Mj7Yq0WiOsNx$9;d= z`}E$E#2Ag^O>oI1grJTM)5^Q!&!{2WYXeV82~}Vgl`c*VgFMQIT=dp~P`%#xg#dd87u9>d8NF!>{wS$;++xn=s4= zjdv{D?y9T-@>$5O1tiFrht6^0NPd59$1$2Ia98g*Fe}0Y3a0bn7j+zyFcYft9LE>P z=lTxz8w1l9^Bp}C^YOw(mF~sd2OI^`nsn}C)K_;O8M9ap?UqcyaUz#^#0w`L1udr% z=lM_5+QYwXUA;})^tnz1EutRM#mhUxlj|EOMX*yO~fjsdO<9@5YF$@dm3C@&!MicZ@SGh>v_69cFdx%c$ixxvjx3_ z02#l`| z$?Kxp{5d3#X9U_aE{F)1=tK8dd0{Z)5k~8a$*S~0dd8Be#w8qnwcdr2rN7# zBx;MO@@84qnCVcS$hstihBTgtjugbzS~`5?)TklcG{ombkJSN1@s8O5D6DE!s$(9B ziN|y3;KGvw8cw3S5o-KWV$Z!G9pr+LtBwI6p;z;k3Sgl`IQf6+#bq2a!$qGTG~jI^ zzeGZTzG>3F!*Nw$g+;)I8vzvSmK!1NxCSo`d>8))xb?)MH zQ3hxzbT7k|i$$fCk8B+49_9O2l$l|^80?AjV|(Ijm&wQUbS*$x-c<&d_iLDSbq;CM z(m`#ar!0@!qnDi=be*;)$;US(*Y}tWsdg+_SaE1jIg#NfOO7Xh>xrQmR7 z)6I@%5D`#;!Yh9wOr&79U#r#HR7;oZ)bi&-0>JSG#r^)`hA)&H`awyNI@Xyc@a zK*NPtvI~plg20&>bWoMcjK*jMEyiOy9#sONS!iZ%Mz%x=JI@~~G|hBbK0UV89!l6I zEsA>|@wFWsJniUw5C9!0Qgak!+TwZwaGoLFyvO)gyXt>fc78DA32mUj(H~4(^tmiLz!l!OsO+0%TF9=Z-L@+Ez#J6K%ER z(+0{x6hB(x9@uRyMZ^SXh3;Y0*EVs4(P;X67{vt0^#v>}BEsfpS(v^jJlC*LE{#dP zkX;|bv4VeVW@Pd#94j=|nfN7u>`a_9fGipmZ?nz^vS+B|(?C{;1eiu6AS*qP{fEEA zcYVzmEu6yG^$X%y_gP3q@haVHj=-JD3*hYuYK8Z%-+|{{owt`_)!Nd}`zJLou>pfm8u+h%Ac74=wdrmmXiVZ@3bqw@0D)vWqh zHqclo2;tXR=I)rkV(ZQzUO!XSYBLYE%=#7G^;XaI^fMSP z8Vs1X_cMSdp=-xGbm)AXySrm0(@#JUzyAYs6km>)p&Jtv0XLVy-vJZ?IW?DY!vZOP z?OIur+_n*Z*RPnz*(wc;lOW_Ah~Av@2;PH^eW>kMv0+@t*&<~Lsyy_ zLM4>8tMAs|bFQxbe*K5BFEMIGNxlkynP$IAD_%dP#b?*get5<}99^-MF@$RYqY9FX zd{rEug?gq5qcAl^G|N|wTkW3x^(liVOViV(fjGipwaNPac*WJ)-QQg?x~`k8Un=y= zV0;j$xbG(w5gLSs_Vu|tox4|!`{4zu<;gReYg#iR2eGYlR~xSAdh5QYlvibcSJoBQ z)VnYcstX3d%^vPJAF?Ty(w*5R(l-WR@**f5BF`^V(I9* z+j`qVbCyV7!B<0sF+M}GoPS^=%5+Yc%0?q%gn>#}MyN9H)rhiO5CJmZ#fZv-dutog z`E)j!BGT|)>}?!4-C!c6>RWt&)0AB_wC*-$Zp*f-_l-Tq`Z{hnCf*uxn)9(47sT+a z7hT4|6K!p{6ohlW+Au+sjOzNdt~&Rodok*1>>)L%br3qvZAo}+o5=p8DBP*DH;1^o zAN`)#!`Zbjmb7C8$yh(y-@g3f+v%z+dvuEfW3Ob~mu_dzhi*1#98M zNfkUNRGYpXiK4`8bJei9zgiNK1IP^O92b;|;f&+}va!`~9+gA3wp&yTlagqv=c;Lo zraXB>TigRM;+zd<<4Zrs4bP`YnI zhx5^6YOdD1D+UMkXuIcsP&OjK?=r})z6(+W(L|U@az)H9j;CT)m+)&NGF6Qe;vNdZ1d@HX%0n_hnVj^0VbnHee0zr#D}N4%3#UZ&mb52?6oYdf)vf!Nla&pznZ=+udPHFHfa`Y=1q8zjtod{I^ z94E4gYfAL+bYG%>a(>}Uj9S0)lc*b*md>MAv{|<&SCsaEwS{dR=7RR%v%unyeigPU z{lRFT<1)Yg^Gj@VwD;KRCU!ozZi}A+8uW4d*_aDMPO`PMs3am~I(d305a@!Ldyn!qHeNQ(8bZen|H1o!nB z3x%!FjX{38EH5ZlJBZH?aW*>?HyJdJ7RU1b%&Vk+jy@S`e4!)_FxVBlkrT1X^0Ddd#pOstd~R6If>cG67%mmI zV4Ain+*h_ll(@KkztE4;$jwxS(PetPeK}}J4F@yitMl>3HNn5D^}ZbGc!l3@?w983 zkF%yDj}CU@wy(}r5ib50CY;YN>RFs?AYPE^JTAE{;)Td_qF{Z~gKa|qK_^h;OP5f8 z6lxq{l*8VLC(uNgPCh(8mY~j$=`rVP0VY<0Lmr zB=*#UM+f#9iB+V*2DotumpsKQgS_Dx#m6c=$%OMCkDp4^0RqxJr*lXTcMnZZ>#E{# z-i8@N&$3#kl7i^$LCCx`@=HG1I^0u#$vDa9h{~SNH@uMs`t+ON z`T>Hj)LR5Uubua&BmUq%`n%4ijF(3d&Qv52{*`NR$aBv+xS8~3f8pkTA+q5)oG5YK6EYq*;~ocr_J z?-zT2@ezQpWJ!Fq{O*u{nMbY!F2ON_(=8{@lna6lF-*N}P&MBBvXnPTjvEPSJOYqg zimRY{5?2MH$AJz}Ze}bcpsi3dv=wrFR|ZDsKVh;3mIdN=uEEmHA5JdvNhz~6k4zpLgFu4NP^iK`Bi^q4w;^9v-Q5I&nKUary8nkS0BR@ zM<&M}McsIMS65pMh@gtU#B>@m`Ig~6J)`&-0u{Ki^SM||PC(58mp6XUrBDhY_5NzQ ztY+~0(2r;rp)AdR2^-b@c!0x_H$#|Era{Hb|0_gf9(DW)OiMt7fwt{)uy8Qcdo0u; z>Im84cQxT7lq^s@h=}@{Y7Chj^i3It0 za5`5(1h{GMA-+8J3j)HF{`isHoG3Fe!Nng=))Ex@(7z^s8OL{^EYL33wiuO~-kAEB z15h68(Va}bPv?!FiW*2qS=lbOXe_E1yY&_ax$Xgxw&>Rs8E>xg1~>qgLq+y z4#SwqvsBZR+ieKab$or({#peNCms@w2k2>Uo=iwWM|i)vKiRhZENbCT7Ph|HM~ryz zlAb~EXz2KVgJtk!eu24Mf3gI1z}d2Fz{7vkWk6$CMKCvyX8Xo3b@{LWj2S)t>$AhI z9a#8nRMwz&tuB0s$i4ODOYeVEteP1^z@n)!u=xBsK^z$A01mfrA9lv0o`31x-46gZ z0k?_mL%AB@vAZjam@T7`Mc`^`-{WrjjrF^I!P>YUnZCmn)0cqmF{0lf!AEK9`8xs`)IhS!40~7)=IF}Iy5h{OMkJ~mDexF~VM;nM4-bGH)hix(q zu-gLJ$)E)`&4X-fY@xQ~N^&OCU%!VJ$)Ze8oXKQ@1@=j|qeJqX?_9~3H`i}TvT81H zvPy9BroaAlbMf+LNfUyR#+oEIw@FHq6l;VzJS~&=lU-J4+q})|>5OVR`2!1_qZOKd zxcPr4{3?TA;g+Sq*#5YvHXpOPna)ItC)@j1_Hp#&m;~b!mLjE8#|6eCm(v;3eA2G- zZVs5%P3sH2Hs`Dwi+ZgB@k~HJ=hO`PAkx8~@{?s_JD? zW^HbT+3O@B3dR&jVD3dgsR$@QSR%m)WMppYRT93qK8ND!=Hjml0_<=?60H$USt2Dz zsp83Edtu&FjNwrwL?SG7Qs>F-#lO!PJOEc3C>K*iLElnpq=B_v-@lB+^ZUCg!4rQF z$pKje7z%3s;{qLkHNW3wO>^ai`AfE{vvO5r<)stS+4DO>o{)&@9(hd;s$)V-mbn33 zS+qq}nm2q>-P)m?_+SWkb8T6M79kOb6?|smfpU-S0hE#s?E%k=teH7%aw5Q5Qio09 zNQ!dhLD*q5E3?ggQ+P~*HLt5>V=R9wgq6Pr&;WNJltc{NfrkZXMYDuUqzLapF=8?J zpILIr2qKboJUAc?6XAJ{nIOQR(HmSMtVYx6SaA+UO3s*&Sr7*f`oKY*n8?x3f+>V? z`WTTMS;Ya}ikaI)Vgfq!ZdW2grZa*up1iH6L`|xBHZL|sd+(IEESk11=2L%)Cwl|T znI+2MWmc4J^B|-+*d9q{04yQ>a5vzmA|9Q>E!7?N)-YxTpxs_~<3t@e*f`+_Yb}f~ zWRgva?QWBAb2B@5=9A352Cvx`<-Xec*SiYrqb-a}HlM-P>~#xv0xtC45qU3NWb;k# z*&EBKYWKPODRYkvn8YS`7DInH2E5SFo3D%2dbTWJat+ARMFSiRVy$IHm7ZikwsZtp z>#lXatE=UH;VjS4xc60=A9ICp)fQ6%*J9DV8*9_OZP#`H;Ac%2-oP+M2pCsd`NDocr*Vw{SaQJdKmCnr`2qTALSu3Fo0)Z z>&<@ah>hCK^-Z>K8k0`gr`vtG@Yt}~W^Rzx^KWCb2Md5qPd=s9%CoFiK8MxHv#eHr zq3%GKU0#*{JR5`Io(U&hup zgX|wE22iFNAnkvr^;>L2$g~9cKNh{TXOxo3kI~2sXb}v4V`{jn)c4v8xf zw#0k?0VhlN2uTFuFxH(V-S)0!hJ^z1Z?jE!pjFs|1`G%uYhH_Yw z&sn_q&K6HX!#_+;Ar6Wbh*BA#A;gV95(@CyfNU9?SrCdp#al#BDCrOsNcJ{RD|$EX0u zD?5MDL7BoKtb=c#(G+~VqxszyYf!wHR)nc(r73dVn?<#qn+CY+tHKLcPMW(c){P<} z9j@C{lcw|kHY@5TT4Hl>N4kb{%6&?+dQYs;XgizGTZ*QyA22UATYet9REgUte8a5BCaod0qGcZEd`tZ;EE! zRd91(Qol3ujTOC+j|$a$n7p4yOi)0pXrH6J_sv6tZqq-vH`i}2;1i?aR>k|t2js-S zC}1g7VTpRPb|pObf~1^H=J`4^4Sdn2QvE>uzosf@kz>Tv|M{R$} zsFNhaTB@4{?>iUl)F8r)(L3N(24wYb`J%1rSAJtF+WRzH2)(1Lb_UzF#22Fx?Ien= zZ{srs+A@|il-{nY0pC_}DS-Xf0CiABD%T&3C6n6b$X#z~6V*8cN5)Px^z4YXCuN4Q zST)Pf-R_nKd^g6J+&)8U?b-g}=#PK9p75<#lIi&{I{A6u?%e>XheF-hZiQ>onlLLz zX!3h|rs6IaoBgueciZobq0a~f82kbUYTw4 zuid|c2qiHOw(o4yG1$KI+B|dnjzKCUhI4#yU&W-jT#R?>9=ja}pwzHzY~m>-#FRWU zaHxjzJ?(Gw`#=P>Lw}gh*0G((HTrA^Bx($xU?hpxzD_tMUcDndl7>}PWE|K7t2^hP6QcN?Y@u>MF)S_FwH*_W>BxH zvdurWm$AH>r-&W)m`)xk2uJZh1%v!!vB-C=-O#kl_-HhhZT5L{855XhNcK7LGG7$i zz7`6{a)iTj?seWQ>cXaeQPz?p(zAZ;Yd>REtdlz2_|!1BDJ9jD+*%>?`WaH%Jz%Gy zjeB!vl5h80Pc__8Vv&Cn1hJYBL(Wg0YGa9?+h(Sp?UwS-Z7cy1>qBGVMe7}FzU)d+ zNLWTdy!wlfZq>A zh9h#76x{ey#n$jZH}_1sUc%@w$6{aCeFI@oBaMy=&YYWc)rEg}X6H-<8cc)nQ&Ej(bd-7+S6D;U&NE8}B8ML%$*tDNYPEqgWtn4lCKn zOP^c0RM~?Qqtfvk=$0{i=J!#`y(^aO`YQu&SUR2zxP3_e-5d|L<9=m`#cto^!4OL{ zESJmwu@Jkf8c1DvjS!sc>XPBJ0&h2gGa~OHK^aEg;9&MHTlC5Ak*cg}>|GaSA2_#h zPL!po>4S(fqilNCW^Vc{$2TN8oJi}cf-uMqn-kLPZ~leaE6*gtIe-ZV=(uEBE8bmlAq=R(2YL6{?POM=G99Q?aC`0?IIlg@ZkE* z&DHa3Nh5-h!G=UP+sNQZVS_M-r%m+h;x(mW`QMwLhPlXy2qPUeH^nZRzIcCi&WP`C zuHIe|SPn-dG6qq_Kq^C;>1e&bYTi>&La2yHxR|K0(e~t1wSSgusG=x_Mk6reM)#{4TD`GKsTalHES`hB;fO=hsS)719iG zD!P?#TiFwL2*f$>M*LF6*(QGmC0A77#l||--z9OC+q}6C*#T63@QAVN_VMuV}hkl!9m3?1*HP~;M!4+ac_S;O# zD&H0H{*^7OB2Ka@D5ae=5%TqVZ4XuaCT(~3&N(ekYg>L5vYlZ_l1_i@Aup3EX)LxR z;PK9eYcNh4)WA=lDDa)##&ufFqz8p7iuhnj8nU)VMECl=#+ZhT2XRPo9|3pCrn(Jl zOOVpqt1CKf%XN_)TzCXklpL{M!|$xqAhYExf(|jb%2u{$cQCcEMqKnulp!H-%XP1R z(gv!1i<;c=7yvorZywK#@t-U@&VRP&R|GV`{Ox z_p|COsX}tOK?IcTGf9w8x^bkr_%O6lNx*vig3u9-&-BQ<#Jd^{2-@kkk@32gyMUKo&s0GuUk03?R6GEV_WLI{W+`8Yr-?DoelNj?&f zlmfI-C-JDy_*Zso3!8O#bURk#K^QT_hN3&Ht&mZ;TN-kAMUZ5zDcUrEQZ&IFu30o1 zH3GgVgaM_Zoxp$hp`|2JlApr3$&Qa;97Kv?{0pOR%x%3~~&?uIsV=)BAs=6o9lVCgtL$Gs-^MtPXk7 za0##p%v*BY&dA!s5WG)HKfEsO<{8{7wn&gggM~pMFo~han3?}vIoo4_t zQvW6#!`dJ*#KH;4{mf!`Sf=xMmRCN!I81|O5XEH3~~lK*uuR^|Rmo&_l}1GxSo zO3@7CkdYI!zzz$*#W?Nu9oJRvIur0JZ5jR>3%P&N!Y<_P1C9l}0viRW>w86)CWhwb}M9Xp8y{n_vx)3w_9Ah@W`rx?M*GR z&I^Bl&_kYWd^;Du^dv@r~0#IaLc zz{AeuBLe_C;IyM~+BinEZ>W^kzBp*pkt^Nq8@|Nt2fvHR`DEfH#7%#` z8B@eYomo#X@xA3Zvw2;fK|9=`ov^tY)A;uphd&oK!QkZPWId8i>}?fq?xBn)>+&Kz z;!U2Xw)@NYg#G7yyFJ-|KKFl^9Cs97Y=c;Yk)VCx1i_)>$xTvlR`?iL| z!hN_or;!?3fR#P8Dl{i%;|YT4D1ooyOcSIb79P@?73Cdda57@FGY^32Xs>KuSBJU^ zG9ukH*!$Awmtu2I^;!Mb&>~RvRqySQMw4YIY>4#a;O{5bK`z43CJz2811f8#NWZulZIXDG<)xiia8|{OCDDsrd+LKZVXjV$ZhmHdF7Yjq9w0K_ zErIa4QW8>q#j!zJ%>wHqsT#jvKW4Jbj0h1W5y7sn!VO};L7G8kN`rvH{2#P=slS); z!4MMzI59bwkxCI0x8*1kb_)SHm$BFpCk;6_3NK7$ZfA68ATl+Vu{{DRf6ZE3Z(F$$ ze)q57WBWpJ$Qg227y*)Ovn{X%f;d1gK~N};kQhy+tSq+)kRQL_P@*kGQlgd5S{nq` z=!l0L&h?uiDc9nHqg>T7*(WI5Lc^nI=0M?0GPNfSMQZLQify)~GaCgoQ!e+Z3Y&s} z;0PljnLtMn(TkDPk0&faC)tvqQzUMXdZboL#SI(n*y_3|M=2Ro7uv|6Da!pLrl&v! zB%CsHjElHxVNYTv+5(dEf^=b?!r)D912G_$Qm4-iAx2=}fPVz#C0$oL`38{~jZiJp zrR@$3g@?(3Qgr96(98j0f;eJ%dFCS!$z%F-$f}{6hN;*h!!U|jBkYiFrRCTPnEAxE zbdDXY22_8d>t$n#m6p`(E(YgmFt|)4>!n%G3`JASsVizyOMuD3 z)?{f)CXpJdjUZ4{JCvtF;Mq{7!0o78A4OtgNJ*RrgblgU)Aj)Q(`p&->5pOa55M&> zlWpT1lmY=*8ZbT33YS!Vff>;Z-T|663da_=?9OBZhhTU)*}1tfeh#&}4j=}AJ@N0C zlioZw563&0VOe{A9}nNB)4A&a)kY326Y?LwgqS(NSJTU#F_XUR-x&!816~Rr-B`Ss z9DcV4sPDhxGvdLJQ3wtOffW3vKQX$C9CrUen?mJXFFrJ%j|x<1uPKZN9gU zc8_I}VHP#32oUf&dSo-wcmI0%&$z*%cJuTVac1-M=x||R%Wn7RBo6h1(T{@*hY!3m z>1=Rj}4=nC^X*u}VguC~qYJ~xKmZku-fIk%?d`{xXQrg!9zV_I*$ z9@6FvBoqvk-imT05_SfLRIQ6ols$j}IOsmsYRv#ApK_D>@`w8tY-x;!7H z<#j6&Q51$$rg{c&w1#v_@-Gvr+5~lvOlcDkq1Yw0w?W+ev52&oF>()!mWPOh0v?w$ zFtd)Gh*O5hye`Yll2gBhadsqGh|g9_*09oLrv8oQi+f(#U!yXv3F6 zXIuU)&W#7V@cf}wSy37YqLl#Kp$ z)UeOs;4Lf-w5Z1EF6T|whypA8oNDdT_+DdOg}8V~m4Lx2V*3QH|d+V*TG`fab^#W9S3+aFR`_kf5hM36w<$}W7y^&&!)_tm0v_p z;Lel9Q!K&9S4KoEpUHZg`mHF41uRaS1){l3(?$G?kaSUta<==HsLr%68Dg^7%8d3O zP2{jBL`+%!2KJ$lr&J#SaEjrtf5=B7)bWsuNyvQEKcc9xf>nLXm{dD9!-_h~FgE}Y zE7(rgMc~mi8OFADy=#}u}69N=&a#Vx=CWI!AQ9Jib)i< zA*b~YxIb&7UK;7cFb)LrI)B8H=cxdjYbsM%!v#6v6iPcC6LXgn!o>4`&={drpAFf2 zpgo}>f`O#`w~gV&7MFq96-rdL<2=5<@BzRcp0E~9oJbZmh`K@&%9;p_>qbF3PTsp2 zwxC#cO%N;bdw22n5*+b}mk_`5>BiEyvt;o8IzpQBQZgpR8}av<1?uKzEztvlt-uMl z?|Y&f^lMHXE!l#G(H4HsQu{0N zXq;Q33znVMnwp&@KsIU1AH_)U{VqVaD77pF-khPrSZ!z6=Y5$S8wOn$@=VU@2n zF4{LO^!TKI0+<2Joqu}pW&{9;*RFvI4Jyonq-a8hjMsx}G=6scew)(@EX-WDguhL8 zsRhs?^;HpZvM!kAaqWA&Gog1FcVa%61VI^Z#t2^VUq!su~ zf$JPu=fI25ey2k-ZRJ;qNsmK5Km=F^mIBY=a2D`{uKFN&eWt(-@A(4g(RSpsL@eoq zi55HFrAur>=Wn5Bq(7lzy#`D;HRO&+q2m&KlCoK=Q1C^pWPK8!;3R@;)jb$CSf)T0 zMMq6{d`^W%-}=<54g}Sg@mbl+^Ykae;K>&!o6iG+h@$&`m+4>YKh#AaUk}{O3AJ2u zno+&J5N3KWu)5pic=G^S9!9LrOd{dd74+Ojy?C14N40s>@LMQ`k5S?CB3BHVg7_eP z6n4wUfahpE(QpQtL@AfAywH-viSeMrS2ZljB`Qh(J;%~oa74v%L|NRA&kWY9E=h>^ zF7wx2hz43=k(H7<6#2l!LYbv(K??g*bp8fAlB(F@W!&KGE(8X^_J;4XD7yM*sUn*i zarVJVuDi~R_c1|E9nGpVJq9f6M!2cuW18lPNWk{-3a{PN_SQR+ySd;l;Tfvk0IN5X zC|`xEdcQ2<^SjR8{_(d@BqlW-!dJyM&Ii#MlODTwg(~bcaE=28zv9o`Qb_QhL5ugk zVvi#`@96Dzzw-ky#{~EVnM?8@RQN=}t5mpM+>ov^uBW6sg~4An4lNjp5I!$u2a&M{ zEz$HOs?GHns@k?{hl@d`@q%p8B_Eu*v)v!Px+ihCAWP?X~9oIu6#z;`soW+#MNmU z#>_75p&tnel#`jgwNU`|2pE_pEx-!|t+iSR6#)W-`9~l4zc`F+jQ@jbv7|j|x50_F zbwbm0352Rvv^_~$9rf!^lO!+vtg#{^$`ukx1a^k>zMpS-n4V0&>|7%1)C2%DAX)`V4szfvghrP!S=Z=Ga;^6$3Ib{xsbhqyPHqMIq75l{m^KFRXj6E4Uk`9sXCNGFZ3( zT@YQ&+vH;y>cKmeOEpJqx5nJUEVJ!}W#p!DL)S@nhDXg=+h0XFK%Ow_%0ss{vbz7GLihcYF@Ub?FM!2Ah8J$#@4G7_$Qf>!dwsfA{BZ zOkL_5vK&5AlJQ0{z_l-b^{?NhxF)Q(66rX+^gWo&9iKI^4N+N$w}SBpwAe#zUKNLS zyGXwtxCdR8h#)70&J5<4eb)Xp<1mg4$)DR{1~`VXg{VHeMKY{WnNZFzSU%swbhSH4 zuOlFYvUfMU`@U4jM0R~)q;7i$lK_^J8^lJ~A*#YU)Vz<2E zn`kwP8CS0mU=ty+5elP!jFSXLhJI_OXcgTs9#rde*vyly)wE$nThqqC-CMN_UPw z3a2()VTlWh+Ob`ai0FYG)_P{3!L|R4VNje>Y_Y!G(k!7xyMUeS9CXDZ0FXf)E;0$- zDxeoS(~B0@sdV;lPF;MffT||e2Jg`kweKUiK;AeV${%nGVXQ3l2*w<(EYY(YzKTJ1 z$f)rG;8~tJjM}B8Z_QYQqDDTTtcK!vk>74^C6@HA7er4-(sm53CGNS*+`Gm~JpZOPiGTc!1JWuwv|SAfi0OoRzpXrtsa4?;C8;utS?cQ&Whhng z<;Zshiv{!{H(5rvh@*r5VcRd&H9dFMHf1sv<HcqC^tVHoN75(S~3daH0Iw{OLg-GfhHlJlG^NOTKqg(ciS`mc- zz;1KQIXwzVTSidV0wx*BVA--S*`ouJ`qxm+mLPHboX_}<%y+2jF8%S;?4NT;<#zAm!*NOfs-?0IMa_>tZP8_T>NWP1F4@V7RA< zy1JuuisfHu55yMn<+pEHx_iAJmlIzWZ-$zv<~WKKnVcZW!Y~N>j~S!5AAa;zcJ}Pm zEG(5r(AS+(75eq`wa)nV->XBTKS@0=f~8!Dsuxe9!G~ya!%Kza`-vcUX;cWGxmO0n z9DBgLbV(saI<>?23=mjL8}gJsn)mrI0a<-V73Tr^@yMGkp7SdYo3pGo{T>}5#XJ82Flr+s9>1>K+z$}#V(Om%Oc2u2 ze*OZ|x>k{K(ilxp;Xzp#8ULg33K-V0w#VW4^?7a39|sTPJU01E47JNHr(*~UCiUx` zGBAXiCYJrj%&f2o{O#Zw*XpzgN5U%W&Sq{kSrjj){l?qErjcoaGBZYvor_+St6rD$ zNab^^@{|Qbs8|<637txp)J(3*elKiw44vPhK5NzH?h2`G24%}B7yTnV2S8IgghZ%Q zI|PAm7lcCf5sFE+?MyHhJ|pCL8NWL=MqZ`dhaAXI-c_A`}TzqYUhIo1ogI1|U-2T#JGk_r%@HhT%$tq324b1}0E#irxRGBo;ArFD0fS zi4POuZS+!L9L>vtiLOEHl1RtP;gOOR@9Zz`OXw6%9RQ*sRoq=8 z9NGgqa~ z9abk3>9YG^Wrltu#J* z9l>bG<4Zqn;|Pk9Qgds9PpZ82$o9`WXW?&PU+y+EDvpPZp3`P! z>bnWJ2)OO+gZI4tEAnnhe?C7kZ5E>SKR7c!HIahEc8={R0)*Snxc5HzUw(DycAx#l z=dXfvvAFkZ*LR)i?B#n;`0nxAdS2P+b=m54zj?^4-llVR?&jQaWngbSvTE-*)xUgu zH0SEvbVJ1F_^NWhauCw|_xOczAbRoNrUDGx(bd)9T` zsWqrld)D-216-_VlwxE)UcWtSO!h$5-@NVzU`HiErj4be+~PpM+%Jmt!3RDi+LN&v z81!V@`Wf83UFdxqZ_Uu>R&m@9Q%K>hP$QsoM!L%{km#Y|VcK@D+@8&>oagMR8_@n> zi3}c`w)oz!FYgp~vY$-fBW)fpzRsO^m#{${iL6t~0HDedjY>EkK^$!jn0Dv~ZqJi$ zO0|L#*&{0DA%Dn@kt7!af>xt^+1cb~R zb+WtlqAAm$V8TwVjdiC;qQ+K&^+ZaAZtL1((Xx-BL%rxGLy@=hX+pPKVXg=!)4|t5I zxB(C^ehF3GuuuBkfkqG!eL$vPOxu${=;gA)0&p(kp%h{A6c-|1c?eM@xen3NF5IK0 zIWD%&eb~thh2GTz%^$;e?X{}=JU{z!>pFXS5V=#&ve=T)rz5rEvo&k;CFh3MzJvVp z$Zf5ZS}cM!OJHdl52CN7#H+}8WtK*u$|Y72a1Do&?~Ru4*8L<;naJXt{+3x(ypIZe z146X%z`1PDhaaunJzxJN;UM?GTzE_lWq)rTk70(6Q80%4BNXiOM^tI8!`{Z80);9Nw}d=J>?VD(2l8!Ioy=gw zmz?MD`xSIxL>YKL{)>b0;_lSUa@pBm1q@g0G+0D^@ITh+-6%@iJnQNE-joi%Iz3Il zX{f15pp-Lu@n_rK+S(<5j#NC+A=K!Rymob&9O6qGyBLSN_LRg!aWi@8v5aA?$PeqM5o$5u!l2#mdjw`D0d*rhC8E*LAv=+XenW z@^5;uB5pRk;@|f{_2-9wQgWi{T;t>Jc8gG2Dh)JK?&&1ow$K&P>FT_+K-nU16cD|K zUg9`ej^z`Dh2moWpUG$_E{>DUSUu7IN&x@0WHnY!R2rIv{eLDWp;tOV z3}MZ=FX!`PANB$Em_ZENd}E#9i0h zawIV*EjjDp$A1qhd9be!#E6t6_+^ODk~rOtB|^CaSJwe~INtz)ghmfT> zYe54&fc^+qK1g|&?DYBRA;jO3B=#90IC68gQQe4(N|Gj_UAi!%AlLgpui7j>9!mtO z2=WXFh4AzdZ3Yoy=6V!XLl5lxUX+sUMJ+u($&(m~o|H?5<4KY>Ni^iXCj`&D*dlsb zV(*ahV%r1UO_1@kwW3v&Fav`T#hp3XhM+vaJBC=%AwjKG@z;p4osg!n*S%S_nG{Tu zZ>5Q#i>QM-QnzxB8o^Erqv;kxq3jdr%3}Hnhpci-U{XrnK;OrL&*NJKPsy{0WpOF@ zawJ#trTWpg*Beozfa`z0e-7=&k2H?4maE9R!j1wQBCvHYx9K=(5)R2Lh(aH(F!8y# z@#kBECf8l^I{v=mOKL)lJmV^!T!)FNI9Ng$RmuA-8!geQ z^&SFPHHIu_O6|J@X^^4||ExzyVJ<%ScvK|hb#wno4W^UlS$>HLzB`TF5+(g77G zI>qjdvc$i&NDAUL^N<4?DSLnrOpS9RgfmcPXy0U{ceoV}D%Xb9T~pP{Gj3Eynvk;54!4>18a zIryj!uX0nt@fR#LWIRK~%ER1A!{D42kJ~a!?D;{gA0RiSp6<5^3ydr2o z5`kWD_UNUEF`cQIDLq&y{ON-xu%9$m4kie1hm@1*!Dq4U514cY+Mp=uKEHI6RKCJH zrK5{7rs;>`uoMyX<*)MCSQv?;T~B~pRf)fLBtSFpGCOt#Mq+6sewd3k`GY@-0PokE z6C!Ew%4TKZ9oGcK7PjRg}XnkaAAPg7$ppR zdGh4PwltXYkTz-X&N06`EU_X6Rws{}n*n!;Efg~#QacUTK5%F*V6V*6L{eEF0p5V| zmE5ykkl7C#r6!m=!SPn*3whzoo_hbT{HQDuQyN;H?se2fgv!yyii=B&yeRo(;h}n#{UND>)B^AqWR9$ z?$#%%&#<=yjJD{M%B`c>&NU%k0h1xri#nQ1wmz=RK(m6HgOHLx7%51hI?XWgpKM>~ z=uh#>CZHCho{A#4=-(LBS|nk#Msq<00zr)Zq00se08$wZ0`?aLG&uC=nKBRJiJop@Y^o(H`>N?-Qkb4pQ#$6bPvSbcH zqyu>mg{xkKL++l^5MbOMs4-}ZGwz?AynIdeB_etfU5~;L?r8$mc1g%MtW5*mm~QJV zpgW*if=b9tebf&p3byX@#wll+_XxyBESO;rHmc8MX+bh+kp}z$O1kbt+C2ZLBaFY| zsLFg5`tEpv6%9vAz$_aICIiDOY#-ZxEjJ_Bqs6cv8w;I2&t%Sjk_PC=H`-Bz8{#m0-Aie zAiRK1-bS0q+Ijf_zpo|zpq)hm{o{OOHX{ucq*C4UCB?N`_ho$44Le5J`iUWQ#cj9( zfG;7B_wQT{p}h{IXK`c#_3g>v;xj8qO+S+4292jAjJ?*>lKDG}`qxj3Nxd{C+Bw@61Iq{?i-vMzMH<)xXAOw`t6dW~nj z1!g;ux$hz1SSOG^@bNdJtxzU=NK`n*vrmo`+e1@1o!N1Jh3|>eIQk4CIrtzqr@DzlV*2$v9oAISu%EZ8dh9~Bv}NJDgxcG=A3 z9eeT{R|TY|Xuk$2odh}Ztsz}G4P(Qw4m=EjCpA`KP91w+-n6==HX5)T$^%Zyct0O7 z^}x!m9jarLR)z(uPoI?XwV!QY-rpZa*Jv6@+R?v1Nwmas1f1raQB;3T0nzz-2Dy@J z?gph@am)Fr$KwL&Df76Ga;G|_frv+zs8vDT<64q6_f?0S2h0$XXLpd8gyRbooW9Yw z)SHQA(&5R07V9~MzaiEQ!=#c96@ssrkDDETUMz-ZIl&U`682Qz9)7X}V!?`zc5C|edvwb8N+>|XGEU{wR)*%EWChfBr zy}}>Al%iNVCz$*~?fKB3GbJmN%nYn;@PU&HV$kBpMrjqP1`gEYcy>7w!KscL|JOdo z!pwqNUsuf;8{wm$Ozmo^PnzP@mrub~Vwa+(bZVDU<5lTnoSgJ%56I=;p4inZre{+u zs40?azNN|f1wF?IFA^1Eq5U;i(7wXejY5HzBJ5%bN6VC@nyq&CDP&qXCUInx{Cu zfnG>f>pqIAY`e_$9DvE#8w*@|k>0H*B9k);SLz-u-mP7-o!dK8Njng2HI@ogW+6l8 zV{v>dO436oq4P&%w#LlsI-%x`N$I)h5N@Hw*~MI@@eQ`BeaXPEl7W+{W+HLlM(hCX z!rbA*a|+6<2Rhy?+>Iu2^bK&=6>VW!9vAV8iyLf{L4xg%6hH*b)EtE*6Y+hZz4+gj zf8qz!-*|#B(vi5p>Pt&Jx4)h!b=R4NGe)8Dc%}n=H@`DkaK+&6vL7gk6Iq>E>~xwCumt=1D!vIKT^M zAVX0E-S`y;pFJt$4XXCf{6_O-9c1 zLBd6}Qt|?&?IhxSqGiR9o<-GPWxtT9D0giQg~Kxpkz6>ECLi|=*mXRl{xkgq`6*nE z*}rhpb|O#_;Qu$&6gyj*5XO)0NVkq$9BwOe_f73CQ@g|1n_)tqus^MsygwKcDPAHJ zH|0NKM&nEDc^JhnUwy|8b5qcB$HW}=Xsy`P&zBBOHCleB3(73%ibBbXsqI=MOB%~?E=+{U7V)bl;3WkZKs!Ewd;7z0Askq*WluH z^f>r`ar`=2W$|%pklJ#$O47t1Bj42&*wrR*ea>{T!g(^hxy?hHKDvq~SjW`~ZPRIe zkQ+X*H4*Q(8p9^aWAFW7${UvyQkFfC)+qUFwPZ@JPc~BPhXZ_46nD##%!^7zq;!Ky zMdZb=+QM}OUIKeX^A-Y9fb}v%xVfT|ztYg@!(W@Dr0)oxgDol)~gMyeMY+6jC3#ri)mlori=Dj(xQ`MmuP3m0)a7N@``03gg z#|P}v-Dm(1@k>{2+=Yem_G-hYzYA=;BI%0}#^tTQo0nC7Htfm(f&~sZdestpApFKF z6HKzHh~7-cKwI2l(ttl3Fr=e%&Q-;8rE+)LCbF5>dD3JQSE-b&)$4cNx2%;qwPif} zE^IHUh}(0Ot4&qU)VEr2OLLW}zc*szv`Za*vnE`hh8xvP_xCl_N_~CLE7eYRZ&W%t z!ami9pbh`chSU&eME#+klzQB9mu&jy$pd?5aU?1c*?N!;ep_u)jAQ)jq> zhp~327jqo3ah@;em;`c!Fn*hx+uOL?AMYofE*@Th?^_RNkIz?vxcm29K-c%m^j>FJ zoWQ29k4`-9MCTv@B7mFMTjwM#bFi`#G48B7Ik8is^fx_V=^(UG0oHXo9sI#N!_IzT z&z0Nf`}UX!FQ;_p^W!VmUF+!iY&;3)sCZ(uM@Px{M) zHGrufdpM_U7p`(m7j?oNlvdLYHurR=mBNy!7HnagD3g}WxjHs%4TisF9i-H#!Kb!Y z+iR2_C7j(1)ig( zYKaQC2d736V{-oh!G?!+e}$*E=5f0}G4S(wxqU-`kPJ(kF(?|$>|}^L+hVYNL#g$0 z_6SY5z9taxoZfHoJ}P;CxP3hc>r@#1XYsXRaP9YU_vwykFyGV?7xjkn%jflrBxj^2 z@O0Jj?;-^puRG#j3p@N&@u*O-gGCEkc=|c0vbj7<2Ub$-G*TZ_Ccq|0JGc|<;jb~e zcpbu4LA!weT4?xxgcIT+{up1pH{rA3b-*TQJLG>BNa7_3;{@>octJeD{y`l&iu$$6 z+4alwcu!$fFkLG7_GZ@~h>hv|O7(TBVyMCAS&cDvsCth6h>fxAS8f!~2iQplDEb;F zEn{EqZIBVE2Cow7h_J1@k>_jPJWc^W?gW8=12++mYSjtR1@yORglO0CpN<^ff7 zVMO%A_vu56>Kbz=3aS-US_8KDS({+p4CstSAf@x0XDK%nLbb=`X6(xG^r@RzpciSI zeZ)YHu;RLY=(S*$Mc^vze%i4H%_K^HM1RdhJi^-NdZcJ|lM`})F$;6x)06&+tQ`6#HB3v<5 z)Kx3t@WX`vt7_x0K+Kb%nFuz>mLVGJ&p`;NRy6D$Fh#N&cdMbpB2%AB5gm2{M?uGW z&mzV|PyMwKG02R;IxH4Do)^#^T5~kf(~YNlufc;8$lZ3j`Uec-$+wKd9#bch}6QzlK|B!8d_81$zZ3Yq<%SK#3YKx zR(T^Zh?I_Q+rR>SKjgB%o1^@6u-i}~H)ntW-}U;tB{x!aYYi!SiWNYgDi{#5WD^o> zdy}ef?apU5Ik9hiDUUmVgdXvG`%M#0Xw{~v9yNkY1)h`~z=x6AoL80SOX*?d@Q0Ri zu~6DAVF29+ju0#Il9y*$?>-B~#{-FD30sGrXCN^{0!z^=jx7Te+gk zJ1S8c%%hLArxMj>@}M!KYJBJ$(d902b~RN8vY5|%H+Gect3*yf;b}Eu7 z_=SZ`n`|pi#LL>c0(|VdNrGrxeAPof2cAhu$LB9(-kOd z@&J@#8qB2T#^=8$yEEnd4*B-BqhuI&lKQq{!(vK5fVHcm%x|bgw(i7Nn1ul9d4*nu zh5qDGe&wOx%rGb__9x?IB$M)JspSs&bv!BQFc>f^i_$#WpPoYN-3a6Jn;2D>rN(d8J&SljO zTQ1tPALr!aTNkP2;sItiVr2JJjFf8^i#4?lw(|H|MI96;l5vez5v5JVVqdgN$_wF= zsD{60+#4}NPVn@m9c_^AN~If4+^M@zf9L}b3S?X9!b}`!ne~Q7lFydW8m!xn(8_)8 zTieWR$26CoxPbI0Has!;;yz=On9v(KR7$it0nwpgbQUle!TEBf#y`XtYK%6KDlGcR z+4U9$KUV>luj$3%_x$gr=9yZ1FFVI}=h<2YcV#a9()S&D_t=A@uGeP<8IgkgIm@{^ z%d8x1nZi`dMN36ikah?s_(SY5ws>p86~U7KM;r_OR{;Kd_dmC(g8z3c3;y5n-(~Xu zS2x!{{_pr7W%7U3P0#j%H@l6->4lj2BOB*!4obau=U<6eHx%uPmjE>E=OlWV;mkzN zZSgyu>Lo7PR;A-^^<`f!+~#xCkf>H|1+*{Fs2?`Xf12d9+%*JrP$rfim5l!uw3Bl$ zWdDI!Y1Bo}{Kf>63_Y46l`qXcYpdB1J8{X!{4<9usG5j#vZG;mi7C;d*q20Wj!w~k zqyKRIKAW^XWudZLv_IgiJnC%cF0eDruq}(^ z)(hwhG1>%5de8lxD#!WiE*3c)6f4T=_USmABI=MKYEmT@SZ&&#$N|1ro(dFb2el_y zIg7b~RQ5{<5>e!l6dS6CNqulIMoj+N(sA-P@mpco)?6#YjMSew@Gl2IwFqL0q{%Eg zAAig?=0g6r7P)3(5;Is22U6TbVr+1FLNd%aWO(2hKTI&`(N1uqHSL{yOrUru%6;;f zbu$oZ#_z^C%ywXyPGUvkFONqikm3M%})-#t9CdiC}w1BYY@wpP{AI-HM%n<%O|&^F(AKVCnYUkt)6-Q%<}M;bH$6i(Pdu+T1|2hbc)at|yR>V0 zm!;+tO(Z#SM*(M-dRN+Vq(yZ~qFK5^?>r0aFh?0DZYLps-iUKT)&!%2%dS>s{nNXL{A{Ch0mum&5Go1xfA$!>J8SxxP9eEy6i8S@zhB{35IZ8q*uK& zEbgrlO`e&hRc*^1y!V6rJdP3VSyMgzq`)HycRfqOTL*^9>j0WKq%Y!KDvL^#2ZM*a z_W}-O8m1$H%FnOzdKuoL6O)(|vPr1X;lPI+fj_ee%n%3wb%W%GdH{gA$JGb3{Dwrr zQ_f7~TcY*_#!F0!#q*kc?&dnv*3&@6(IuDwF{G2p&0Ow4i}A2{jupB-3@xdsr6CC8;OLLS7FXCv*#Z z11wT=7j6e|=4!=ez}Kg4UoIH`%}QV+s=TsR15(~oq8-RHFbs$B`#UdiCSCLL2!!<-!2xxrNI(iR??s;QkhhrK#au2=biVWVwE|mhca_@ncKv@UZV48|T z*J_0PlwY#k!QRIHqm+;I7Ub9+PVA>_h^PUD6d!|Gn+0hC?P6ix!&gdIe#~+#Zmpei z^G42^6jfNrD9*pzl1yC*23_c+4yr?CT_N`Ytf-yVNWWSMpEmMLeEroJu-94(h*#JR z`oyUqH1pQLt6-?#5tDWUgj*pc-eEqQD;|sRe{aV5yN`P`l)u}wzf$$0Wc!WgL=EVj z)E8aMp+9t~uwgWNrGQU5>yn1yNrmfb>d941a6xgzfz;wzaok6J1J{x7tNegrO`ToR zMw3wCK^T9E@&D}p5m^5hXNr}JF-^z>l^P%yg*%SiJySbY=sW)RWdacsOnY1##|9}8 zp(O;N!HqF0?T;9Cz{kxeabLl zOo?N3IF7Xgl!b!)pFLx=@uNLsiKGRAmNCg73vSPOR#5|O1uB{Bf7h&40*m)&||d9Pu=^&h#~y~k>V?@%MU4xR!` zGMwXIn5Eh!3UbP3?s@?{m9n`RWSnJtSn0YnKX?#j+v6MHm-Tm1tn!qzJ8fl>dr!^T zk%a?vnwmooHD#7Z4q?is^%GthhwffT;?kHi$1WF!g#!n9i;R2m^MY7NcQ-&bzJ0P6 z-B(YHiv9kMWujLu{wNyfG@Wf~T^ag}CAts?AHqxiLTPoW5p#kBwoLLsQ++VifHAFO zWLka$m=y-x@2Nld-OSnB$UT}E&lsD+4pD<7&X4-M{(G(j2${*TB0n%(8tJg z(cZK$PDb?eK=cfitc(F^W`O|LAx#QiTcEV&PWUly9|9@RTHv%y1_+zsy7z@!Leta} z3~$!N_`mJvugfR8ymHCMx--HeMMkGw`Z}HM-Q8T>?>DvXXAd7=Uwe1Q4^J1p_$M=f z&(|*jj#2`A{%@D(S6?ABN&YcWb+3VZ-I^Zf{G3yIU6U@_5jDF@v_a5M3;&huMBAR5>RhzFWv|q-Or& z{3IVho#Hwx6q}cGw+k?>KAhv-rt*%}Eagp(V*>e;+P#_He0k)r#r$vCYKHkGZ>cQU zq9CZuR0O=BBpfNd$U}{bnoS+2$h3CWCg2j~Og~UH68;w?6fNvEhjs#}2SdSUV&nQ6~lsO~-L#6EX$U+CX42 zj)7uamX*(42?xZ(L|UW`C_hmk7wF^8;0nVjY5%;8fra%!VBg`R2@AH?$MKB8BO{T% z6qWiLidwg;*8T<{^n>ESUZQIt5MAS6NSKXSiH!DuAZXd{2GG(StX`Uuh8vaQM)mJ< zY>fy-)hAMk=Q)=kdA7JIkDXFQN5K0MO4l(*dErA&4-J+IhY zywdW;rC1fZe~y-IATS)i5oKQ+sX`gNn1J;onW%Gh6Nb2nz%;nP-j%nDJq?_PmuOAx zihH(q7=hUsrjTywykocFo7J(f&xHY-NaGfa^Ak`1Q)8rowmxj2jpA%1nDysoZbGq%#nZ44uLMQZ>%*7JtEnd;MRF{#)OOM<4` zQ*(-SzW2)a?=kOFCS`JE;!3xI{qaJNub#Z@VkKpRON0abQjZV#DKy6ZbOlCy?Nii5 zrVr2)3U9c0Y^AqaS8QXVG}LRosF2cpHkLOjhNR_tNo}4AQZuiU@2ql)Eo1$YT7VHz|umN~dh*4{cnOgm2_xup_*Q@)yMW3om*B-Xj z_S=asM2A1^!gj0WYUZCvD|~7%-Db<@*&>?V7Aj5ly1HGh(NM)^PRy#Ro%{4(G8W-> zH7#WmmG*Ao5U4Y^YNU+`+l_2Frgb!)KbmWcEl%F>0!UB3+B1HuXm+(oh&6vBIHm#N zkes6QbLDO!$7hK~_0Bh&i?SQ&i%=Djp}zDgmbqA+^RVoTeB)@_0N%5f`8zHbomSfx zfNF=Gju+TbiPeVb^P$V!G6SxJlU-zs_ehZ8d##@VjIVU$+w=~cHgKWf?K$TN@*Fb+ zitynkQ%mxJ?~3uA2xKk?PbaW$=K2o^Z|ea@cu%m=PkNf}tnJe-?rvV;A{4Y&s2NpgX6tQOe5BC_n9@{K# z-p9=cu8JnJ#kQ8_v+`b@Nu z0gefM@rnmqiKDmrj)`V-#IsmHMO8mQ`ZKV;!qApSpV>dMYpQ~7UUsy^%x!Q*n`t)7 z?}8}l71E435DPN&_SQeVkX(D%dtH&5PkNwYob)pdX7XnzQ+Y0QP88*8@7>Y-5FRso z3(IUqFOv>tAbsNW*B7=vt4+#EQ||;0K+_?+|I;1+muh7G8Uh*!$IqS&l?qUuD5o&U z2p4+uiO%1GGJaX~JA(#Ac0agen;c>3tsZ(={?qXGW;_D{xoOL*A&GP5eSMsIqYGux z*IyBI;EjXdy#Jg_%0C{56-)~}v<(@C6+5oOKVyMY)P60B?iU~`X2o*B9tBas02;tSY*a=)Gj= zQS#*N$5PrCVDFmlmH)a|XuwSWxmB&~0MtrgsL3?!Qw(g<%hof0R6$@6pMo@+K-3U` zau*u$nar429Py!^dNqqnmh6wm%RW%g<6nrSjVZ4!$LxTPn!mTOf913S zNUeSx2Cu&UVJj#&w7S}6wyf94x!VTF#^)qMeI5Us?v+Z?(As)Y({pV|FG4YB70f9m z4Wg*_hRQPa?5X6V7OP_g+K!>)X#q_DnDB72({)*@Gn}1Q(xu_wJFKjGyz?z-u_WZ? z{WJNXY6}@{y!bl_R6Xopt%kY zgzgj01=V~=yhvb9vWRv&MLyG_f*?b-_<6?Y=)Xtk*jHVODuGr(>6;p-=`{itg?W=r zEYEc$wj|1Xo*V_Ia>>ytN=UN`DC`fE z*k=s$d)BDd7)FF$VKO#-(6y);Pc85QFpjZ*2|ZiAh=z>4c!E+~|&17%JR3 z7#^4+x> zt*x^%r@DB)iCMA@)x?shN(F@6ndtZms0hKm?THKE{55q*pg zq;!2u$^t|%mzyP9dj8ex#EoNKvGop!nWYC*RpLgnDp04>nfSKq;Qs@HKz+ZfM{)}o zTtOP|R6gB1aku_B-MdG)bdS1!?%aRPR`B!{J?9hLz(1St0VX}hg{BhYG=ejUCtc^JWPXuH3lFaCA@w+3!aD-2cTHmvBB>7EP`QS~F4AvyMQgVO zAxy|H66rC*fOFi^7%Dikr89q95{$oEk0X#Bc9XdH)L1G>Lq4eFs$ES52iRlTh>yte zn*b9w?=)@4Hc{Mtd<-;)v_oa*81w|_e*^Rm=Jh; z&5zd~t94ZaZj76Fir~#M+YZtKCy)A)(B+lf$z8fxSIfPaPN3}T=9FW|@wCDG1M;@= zlLlW*YIa;qx={r+xzn)G5bRNOf;pz=Qz}d%^`s6-99JkJ3#cmv>kEG zIvtdce0&~wgYgM%TGxN|(Uq?QdGOY&`<70t;5XV=V3`fIQfl8yfyvR-2sB@@ax`^A zSAIO?PRks2yR9?G5dLuov5YJB1LrAEp9*#?|Ncv-=_gL(XCh?^qgSL{J%8j7O|!d( zHe=|o@#*21DWPza$rFgkePfTe-xr!voGLU$^sJsf>Z=6ls!-Jrui%b98~TT=zem#eFcAmN zLf|Z@ZowalIfQ@12VTA+#dWv9=6P2(fcnOZ@4E&X&fh(jrg=qsMMwhSom0la`)pfh zIB}F*!tNb}JZfne?ffWkKvY5NTDrLoULX8&5?um-lXh*M!3ngVE}_E_il2`Bdz6&z z1l{9b!#ygVkj0P3&2bDUc-n46XDSxt>UjUhAvx7?L{op08v(_Eh?8N8*ONaTgy@_n zg1eplzW7j;;Q7kC`@*ZB)-M0VF~2Fi#(T84?vCd*wI=h3CSF)e4F5*px+aGWbRi2D z?iVB+sd6%Ov9!+a0Yd*MgvCC8c%!;%96JoX@4p`>g5w?);1vDRpONaxKZCQBnno!6 z`@cr<&-#B5EE6?s8u|G6?e{qpPi|nPgZJ*J0w6^a{MKR&)8J7gj3w0>?0!V*e^A$v_2294kVl})UW3k#$5=5*f0#FdKn%FQ5fQE%o zl>$SCiBOk9W0p>3!muGawF!HIJ*M8T9zD9cy#Dvk*WvQy!-t#OtIMm;|F|9R|NP^J ze_dU^yZQLT^~W~}jv>9h{PFUq%hNY`yt%r(yncTh-T+NBXawwyHi&=Jqc-qbT5MJ@ z?n!v`C|q8J%l9|0Z^GqS_}$O%{&|fLe;*z{zQX_i9Rx^(`CvjxqVth^iIwJ)EkYyT z2H|=h2zaDOJzDn&=K;4A!6jfyz;b}0`H34*Qgjdso+i@M!EPfA!g`Cz+W`hSUl~>< zs>-emYZ{C7NgzaHh3kJa1wCQ(Fuq9RFe6RBjY0E?82XAqGKdBYzG6_YbQXr1BYl)5 zm?c~&oF|ln*yYhCAy_q`JxA$%*Mz!6DLPjbTH%!tyEj#6>#tHl>;xO=|oQnmzbD_!6DF7X4nIgKoyH6wK;znHbx-Tiq5FMF(T)f zrh!-)Ast=`sp85A@y1v>3B$?=DF|D3=P9KnFz?$K*9`-d)N`M#j0BI3dT&<-(koOu2O#uJ`&>Z4EJu-H1(zeKXn76?1Oj1p;8%P>-%l*)gY5JU?ViKJ&Asr~?w6zTRX z5J+WuW)lU`6EzP~ng+wDj^NoRVc4`$VU^Nk*9L+XxPO$&oLF#afqO!!2_V=3W$!E| z6ke$OV(onnh@BFG=-G6qL`5ji(?D#LKqgtm?l>{P%>seNoAgi+x)lz}kXu&`1+{o- z2b8dS{ziY4nqtG^+eVaz=-GS@h>e$Jp67trY@^U;d)aNHz-PC95WC8m+VFy;h5c{1rniGr=PR5Qze>G5RpsOCFx22s)2^4?*&a(HkofHDaKq9kfv zHtG;J%z3^NVY56xiAn1uWhh&dSQK%ih%8+~Dg|-F`hmMF{Q+pnxPe4}rzH&6XMs@U zw?2;hmH>+UwljPn=f+2qoW$y~NsZ11+3K?CJi7WMC$YLqMX*x2bC=rL)%LlR;Epup z_#1yEw8B_?u9Hv%E1oEBUP4PjO_3*os1>O#7De#t<0KVjSOX<8czV>Os%PfeZSfL< z;8imZg%>ZO2wvqVg4T4taY%dVLaxl@S@it2Mb}1cFyPs)OqT6kZv@%iCUfv5$LLfu4$?F1ldPv@@Sul5BR0 zJRO9MGaa@qX&pO+a7{?(mXe3ft0PK2KxWDQV5+uPU0K0UIoO6X)2XtuAvLG~DNTQ2 z+~O4xRG)1UhP6EeSLI(7z!_1?kBXhI5j+cTgt$|987_bQ+uuXWp&=4=lnoy~|Mb(_ zZQvii+`}q-~Mv_!;kO2yZI8vR#mu#=8Tpv-hITkd8^2mfn%FLVc~JnhM6x9oVz4+WRC7c{vbV+p1ZXDdQ^Xz*7J`8 zD+}~-*0HFfwi?@EM0)^LDBXqZs<^kQT7PA{{r}u}VQs%MUS1XauZ_3+YN4JsVY6c2 ztk^dz_RZ40Y(m|Hwh4U`)|q*KZx!+;$R_9}*d~-ssGHC>p>M)AbKYjo+st{JIqR7Y zM|s}dc~*b`OoFMSzGfR2$+AbdOwJ! zXV%(nG#hphsI^6YgErckoev`=zEVel)A*KGhZqa@T*7cv*SL3knj+ zqY_t6R0fOyZs`sJ%Wai=A)M(T#1=~K7z!#GM2UMboLJZiD!7jLzhh`9FJPPZVJQ9p zbiixpZw)p&@EXQZX{V=NlS=SWJT5_b$xHC;!@w}Cm*ZOydL}7*9T&w+d1SF%C1e~M zp5yQe;h9w~vhq}S44QvS^l_GR4+cAvmb_j*PV;gcKMmoX%Ic#DluRap;H61qxh%PR z;zdrj;9AhCSf|f9WM$Eik?FA|to$Vu683~Vk5^rLJ_w%0&h6Oqhev|w;m&?wX5=2- z*=7e#hk9mGC)ferkW%)ku_GYp_$>^;)Wa(B)Zc}Gm=@?Qn)oH2MW6tPN49b5KJc0r z*EAa!@Rf}~UiB?x#!(r$yUYIo`5%$YmrFbWHH%Lx%~)_|>m}EJ!I!1bK~`0Ex#B4gPHdjnU1$HcTnVOvtL(9?t2OC<$sU@l za2g3qoKys-jm=5_+mdsR3RA64?Z5FF!eps}<0TJ@t)T^FU01ZA&B}+uR`>p4U+{fQ z-qnrG3YyWFEblDLhYwf?8Ac*qthfxdO6lwJx^C9C$~x2HE}GGQi{W5f-P)`*{w}Yp zwret5^@8ltF#Vbu8pLxjHZnl4s=rhwS zg&+QgCom8q;t5w?D;U%6(XTkHV~gf~L4zxYkc?mheSq5zzm?=7Om)0i2@z@@^*AS! zIG-a1A`RYumYP?879o*b2Ji5&v$i889hyjjEYG(MoF<9OZPD4aElt$|2nY&F?;2xh zwy8|BS9|Ww)@pAoX=u7u`3%+JTAEbA-J4 zEF)DKlI$5l0_T1WzSwPypN{SV-bgohb(5Qx#*grv^%EELA2+y}RKnW^j&`Lh$8Fkp|fZk6cuRt@P_y(d_x+RrrXr(X>*HI zDB~yQhO5w{{m@$;4v!}t9Kt~q4|axUu~LeMky3}2#05vc=h`{GjN%9#Uq*@EIX=Xe z=N*4!T;E}h{70-&uxV>V*Na5(A%o1|MidobaN$*dmo8{D4MfqRsPVwkG&pVZ?7^Xe zQ_uib2XO&}rLAlUIUt)3ws9J!yTiR~mP!Y8?jQM&tSkKRD9_e@c%556`sel0bYO_X zi1Gc%0FzS;$4oE^%0fp1!67tdEW=cZ1KY+a(Gal3OSp+2f`L!M@ZJ>Vw!`!n1!v9n zw)`xAV^tJzpqc`uQgB9QZ6Pt@q2s)^sL`&!`n#^#<{gCbg6<*hLHx#m+@c_cFinaw z%bU8a3zKh)tnrJT6Si;QL5YOWTY;OEE}Fx3b6NN^W3sLx58qD$tYpZ9-T_Q*hi7_a zh=Rl_@RHLhFtrMKBuD903&c`7C`FP=L{g-GtcUB`JkWrrss35qxL{$z$B9;mN#Jh$ zXDGpg_uE?lOfh^}6)ERiC_nXA3h>Q3^LpoLsQ9=9h7`U-wV&z<8r__2fyJ1{5v!EN z!G}6Wlu>00L*WvqJI>_9E4m!fg#smw0azN?@}VIv=nM))7@+6CZcWzY8w$gaZD8$x zgK0X7@^D|@(RHvZ!GcxKwonJe&jPcUrwBsJP)U6dv+Hf+2*~~;h!_}p!jWCOBn0w{ z!KCr_tyz(a_xm1xj=irYBS;eRM30OvL7R)5%|)q3lZ#p6b#G5kb{408*5V+g07o1f zoSbIx=rc(a9BiP#D?fKoX9tqOyelH$mq0PX_fQ@{Fc;laA^&O?VQw*>(1OQIhH*B8J9MzGDH(H=n;wjfQNQiq2WzguaPn0e&|Ce>Y9gD4$O1b-S6sRP1#+G z9(5SG(%_*mbT?F5e9!TnYVdr#8$5r;E@B;~V#nw&Km2-43(42}MC3%rwuZb1-w!ln z%7G=|r4J|oEJ9w!5+VRY@>gJg6>&U@3_KZ(CjFnJ{+-e2Nu&7}d<>##4W3;D>9;ZM zgM&Sa#wG>o1CttN^y&kXisGKm$wS+Md$cXI8peZ*J;x;_6wa8)h=x-TFjYQpFGYqk zztYJe({M#OT_);DkP_vXGzSh5n@9Y=qz-Bv#UUtY9q)p|MfSMk=IrNxfrh7QH70q{ z_k@Qe9QGymh@ggZfUE=9>%Rz{acAl(&Uh?OYP(?}uYx zb}~^eJfLRJS>YDlb2V4#6`oc&Bt4P9aaVgBv7KXROobf~0|dM4kzQNiruG)|_4b(< zAd*n-B06~a!vMRl-zJcMRxu3u2x;zIopC`lF^*juM#PC2s<9W@VLXR;3U!MZ13ukt z+jlu7RB)U%Ywwy0T=Qu&P6H&60-3ilt8J;MD8yb2I7e&NUn zA{_@u^CZu828zdB^K2Xgd`j5sw{_bpyY2CRS_bZnW`+->5Uitr?{f4XqXH08-$2P1 zF*!u@7zoJKPWIHIZ9zOj^+x>W*%6@8Gc7@dME1wR39p z=6Q-hO&@mH5R_1VpA_&`*dB1j0qAcZ={m3nob}a_nBot-n8r_inLPUW7Z~uai*IMuMrtyLqs|UJgOU`f)XDDFYQ`FH%9E+j{WkU7r|M?nQ^bWemec&5;fN{NRm)N-FOJ8oNl?Dy9BM2FZ+FS2LlBXCe;^iAUv-(6^-8dX(td$ zVV>(+Cc&?NUh6umxN_SXk~l|(>qJII?QPq~7;hSGmzp*~4nYzRR{y>RS;jofkOpRa z7T^$*nC=0&>;0qn`QCpb$KgJCBcb|nJy)fNs*k_ayGxQeKy?~MX*^2va=LkU1R37= zRvfSl0t;B#$BlLWses5=Z)tGW(0?WLt)MyblYd)(a*+m*ev#5aLG?6d?{DLJs}9aM z8E6?O9Ec$EAmY?LvImMi2b`mP2ipXD(3%Bqz_^=6D~$O+?iwp?k{y> zlG)I#c$ms@(^gLR{;q0AhZxl48&kQAtUM31B!8dv;xn5;Qmsk+&eo8iokqjjY-873 zJX@xJgA1DR_qNDNKjD`m+qR^=&Nq-lO~2GB2vNi&=#Ka+s2@kRi<=i zhJO=Ml91Tt>x`w;At;T56w1@xf2w$YkO|~o>5q5&=H>)nv1vs~L}C|dg?}G5neS^K z?uT#8#;hZ|#}}QBG@6BA@CLPE0PHaQqnE)L6)LxTo)dyjm$oGp6}J-Y6TDTI zvn~}Cx8p(-VknoLITaSSTWb{M9G9|J6&ANvh!jB`mx_257PqaX6ki*cAA%JZwNdV$lHFxC3569&=3q|PSWO( zS6<839iVLP3gBda2XL?pvhxe_aJ;VBx&9Rhb`=Duxq=+QJ^(c!1nBAja(bnt!Itih zKqrW%yR)+c2xz4NbOXD)S_0h!0oJdT{dZP?6xi9@6=Y)z0nlq}=rS-dG5?Kl2nYxO zEWH240HlF#AR8wD?d!q==m2*9Bh#yd9MB2q`dYNrAF*nG*5)!+Ajlu>0_bfa5NAO) zHfL*d;48-JX3gpZgs?HZ7AoUpB?Wf;L%T!EIaO?k8Zb8hxdU{5FC|AMVS zPF8=mWaaM6rtJiBaR(|$|8MXsg#0&V1B3v0*g4q+*f{|}7XZ-9(w6Oylv>`-z&}Zj zKVWkwD}P^qXRtHC+T6hn=nt|6zP^xs-ON3J0EnwQ(BJp}CH`}V%)tS$0$D-;7C@WV zYxrCJ6$V=WwO2NWxPrU@hU~2D>>L30Kc0WDj9)L*3hd|e!u z0A1Z)T?nB6)36MH|5Q=|LqL{50R7)4F=FRofAz=fi{t+^&wud$r-lBRL)P8F;m`i* z|7slY+PND*3Ghen4(6`^6>jbba`65?4*WAv7x!@tJ_a+3vl z0j<=3KoCpYzl`x0uI*&?=NAW51G|C#_+|kt96TKV;IwQ(miA6SH@8>!{Ye3xtp1Tw z#>ox5MVQO^zD8ec8+&({<7_OC*BF&&HObomu~-x zZ4Bl2<}l+NDm+0_0_hqm8UexNdmbf6q3@Q6#2NE>{TIgAED}y;#}-wdl#%N` zCE2-D1nx=*a+}*L_swIRql+C&VCyS?8{_DZL7evH{)Y^m1xNg~8RO9(9#XxX@3wZv zplXcBpwvkM!Bt7Y9wOkzBR>UA)1LfvUb(ndZaV>q0^y(aX4s&>&dT_#L`3qVY|{Nn z&7UThCbVyu)yi)BeHV##o+@|+z)A(}>-1k<rMwPew6_FGqo(!fGw^GZDIe2u5?b)h zf^0<4A{URbhS)06&|(q14NTr+RE0?p+2uym7f(I=byuSz7een#Od&>pY)6P*?{khz zxOYqH3rgDXRV`>>Gq+M6U*a#|a5SZlHjDA2A{ZokvbGYi^JL-HwbZP`di&IS`UspQ z+Nu9^XlWAJk7CUZYe?M>Iry!zTFuk$4flT5PTp1U?QRRjOWP@v&14)-#b$~3J-`aS zPBNG%qKQ2JUqIeId zwzU4VSXM=tydpb-%EGt4bT@2;bAEoF$t$8-7<*4&!_|IIxpN1nFZjK$Le#A*zJc-# z&$P&x)NiCVGz)44I6?HIOLH~OQD|GI< z92g=-y*lrj-`JpUEoBjt)+0UIdB3oJ3kq*W_g%}~ zd;Spi)$uM=(T(uHGRdr=KnA`pY9A|T+EySiof>iHpgk#nMjo*&dF)=nx zf^Dv)sT6MB54a-z_d$dDIjcUxH;q-a`&s8!L~qqd%F=4~jFy)C;g%-eP+31(NvO>! zI$q-#?vRcj-zlk@N($w`8`@$VvZt;}@((;cTTpq!GBW4wJr$|KsD{LdrE_akjcH}` z#4^qu|~;yW^nq}C%0Rh`n?I&L}286notexD`hwT=94NXyhHM~ZI)6PHh} z*|y!=uoG4REvbRqSw)snDRq6Wv-MOj3z@6LPOp={(!j(&OJAcZ)he+AH9~88XKB}wIBJn);KdVv+ABbNRwrQlH%Q%undco@V<1%4Y|X{h zMBlDcNt%uYWOPw#Lv7pv%|V(iEkPsU?6M9oR!b`ve?T&L-d80<(;~rkDUfNC)|&1I z`8-O?57!=^v-p*7<-C5siB2o2Q`>&2uMK~%uPt>>x@otJZ6O|C)nx#M%A-H`%GU>f z3EJPGlZmEYK)DcijEc3Zo0IMmeAd2*sPUPS;} ziRSD5Rm6Z~wi+kNaPTg^PDg2MKHvAut}ceN17D{5`$3U%<0?F(N`bpC>SM-NT_fkr zG`cww@8mTjIs82Nb~)>!-aY7LwcgzPNc|VMtmt&Cl2imcL0aep`A@~AXZ`r4c8XbV zbXx`#R7^U%y_oVM$ArwAjhCK(p|^so(B+FAmfTglpvRv+>^;w7?v14k$;Ke@$-_m3 z+AKesvYQVG1|=gSxjxL6*=20l!i^BZEW(MgofLUGwB6UfRjCig@yc}ZBi>3-Mv?cx zl$ncFGH~0QZ2p+T#l}-hY5x_G2-Pth_8_DyQ5Edto2{$OT`nhyHnj2`I32Jzi zx2np-w0vpuxo0cB#!RedRJfQ?yM}zBvmd4XFj@K5^g}Q5^GQ))65=A`o+>@0D~k!( zaNEBh^hVO6tvmKQXhxcUbNNM-Jr_bfbQ>k2dBDYdI9ZGkJD;Ej>kFt1K@1AezT0wc zZSHZ6hE*MEv!|as$swa2&H@fjvDoCHV;h)?&QVp5JlJfK*O*AZ*3B2%qOcjXORk7V z7nyjQB+6b$H*r#YMHL5udq*5^8MLT6XORX5BI`%K*3|VLeR0KqR;Ct$rOWWo{=(M| z7rJm1M2=|2K|D_ z-UnKLs@axsky;kL+xpHnb32o0UA_fwdn$SV0uJ|)!#xdle(LM6elQ4WW3ppNpH*Y( z770)xpF~2;0-@S}=W$U&<)J?vz(%Rsj5q(3sRQqmY%hIjAfZ1uv)1WL^N2frseUj~ z0y?3cPbv!&6Cq1)9Svk7=aJFtG3}Pxj&qzz;rBebDFFFLms<+WCeG?H-#1tggwF_l zDW|rsS1h$!`T`r0qQQD_MztX`OfsmuDb_$`AjJFOfDfjBJa*v|i+T6Bf(%l;1=CU6 zua>@jQ+*fPb7jGp+4}mQ$2&T+Oxr@kQRO-m>NN&3>IsZZIb&fcM-w}^miu8r<&+_5 zt|wHtvM9EJF7XSY-9u^N9MZh0M2tbxVNdK=bvLyBQgq1oIV65oH0c06J2toHQNKz2 zN{vVx%5QOhv3lPQE{&o=S9mqXIq~hO8bj3;E6oBf0$3Z~yA3OrUkOU81&kJ1_3a1I zF=(c+Ftz1o1}3tt1g)Bn#wuh~G}_|`^+}r}<-OfPQqf#8V1m;{D}X7UI*CPU1n@6w z&|IG0P*HKmqS$NGPL7)sB%>Lm@d?HwX%l5^5<&-wZt=3G)s-y`E$inZ* z>5I=`ThS)5ex=dB6Eyh%zzmnF22&qQ+Y%a^Bh8iR1_{?zeraPK89096UK)ajR#zZg z{qQ}-v|F+iF;c_1KR2C2Xp2GwP$o~6_i^K;>I;;8Y3+e&Z7(%cHrp?(d$>Iz)j4+C zP9x)gXf>7M!Z>xxu*|xr=0izf$HWR+VUb;%r#Xx41(MVCCm#RhF!UJ}ZZyaV8UeL`m>ZQNl(;r#dLr4yT0Y5?xwv0b*(y?! z3Diw@*#f#sj7dMU5RPCRK&~p)*x#J78}%HMx?Nk4&@4zcP9HsZD5ebz1lT|xa{Ugc ze$~k(A4E+*rTfq3@Ay}!1>J`jF)>(?en!aZc}!a=qcB43dU;-pzLX4cOG+pN{NT`k zFCLu`jg=bN)b?KtX{W;tA&X|F>W16fC<|VO|LQ5aEHF1(J@U5Mp@HD)q=YLd6bdig zYj_)Fy4pWqDZ19B7FjlwIdh*xhuQj?Z0`PaJsm>*2t5UlDpYh9B!dF8pEb*~P;csj z%;z&H`Sd`m(&lyXYcSoYVyHr5ksI=VkQ3cdeM(Jt5-yJ>Bs}ZEoenc>fTgF@?xrg< zHuz{`=t}aQ#1&&U@KfpP2~?wPDEFBzqoH|xi0Q27W=VG=#Bh5la}N!H7l{xLaC%^h zY+&0oIy*hTf7JAu`{sFu0)!Il|rlWPbu>i!HW)(@&MR z9qeq~abx7*!x4cBCi(NdJdy3Q_QAJD4($6y^lI$TD4w^< zq;Cb!$)fWwJhFxcHYi5+ZtC^tG_+HXv`@p{YTtF8m~=YCJb!N1J33mmSsx9igNo}LlTbW)w@8&txv`aC?38k(mM5xnUyejpDBJRpzAkO)5s_ zf~_w6wksCmGiS!yW>0tZ z!;Bc7uGr8Eq5uWFmDuBdqqJKSL$j<3xqj;&tDDpm{Kiy&pNC8~`rTQ*eRI=+9rqnH z@L-)0r8r%vbNnK5F(s3zXRRDhFo$n3Q)<|(-3Ng=ex6IL9!>e zwpBtLK&s;=_VcD+#Prno>a(2@GE&KXmWKerr+1c{F2KI#seA%onFO!yImld2{E*en z(3&fWvufQ;&%OzNh4_`A6%I*N+ZsMo^hcpd3#lnV^MMvSzZYRF;6tSVD0lUTx>w$f znwJ{=oNyTOgVCBf)yKJR{aI}fO9B>|>*cyYGcl%1&C_q|)N=>Kjb!y80|Zh(#nqeq zbomsijdgfh%KMMe`>LaR90&1gD=nCAUm2J^6I+=m5tUtkT)ho|9Hxb8p-dWdNMgMQKLP^m`a9-^v1?0rMv^sQHe22rX%bk zj5hlC0R_vrXz`vwpsvHBp@IzhVRRkAap#XYw^+NT*6DfUy zP`O%2FbD=%;R`+z6f?}zVcdu$#z@gy=Tbj4Yo8&CwIj?sN<>X8%lUT8d3xcTWGD2$ ze1)weRv$gj2wdKz`lTKg#1){(vQe@>HsAY<89$zm!((6|HofWSdh~6zo{F6&mkmv= z;x0IUU%&6%SM*4yq}TnutviBB+*_?Nq@OpGCtd{>7QaOC)eMl?{bj3$f6mA;8PD=` zxW=zthhJoXh-Vu1xiV2O{d1}F%0+EV`RuOMhYUp+3bV-VJPLFwr^UPLHam}b9X!jn z1*lAvrH|YqVal@?DuJoHKWfbG@fBbU4RJnyo$Zm%Gm8l~1z!&2ZS(>|f7rq~FYQIDmcOKjP5mnfa zJ-$ohkLR8j489qAn*$b-Ey=%whzZL=e=K<59fYKvq#@!#&5U#_%6@hifPd*#gKhDD z5~a$*<*fDZY70y>PwX>;u0Ndhg}=yIT=mPe-1SM=JK}N*X}NkzhG zrD?FKsxH=T*eJ-8cSi6We$mq)Zm`BhaPX0CX)?-A!OTQsw-0(ve3%Yp)-3dzt^66m z4*ljj+-581^lst0b$Y38eUFEDUSLIkV-Nab!mH5XiV!K;GK(Q|Bi@&h5EC9=K(Gx` zdKOV8OoGb8U95l@AB%+WDPZYn^nQr^jW&nfTECUX)u+|Ydm6+~)}_)9G39~^2zu{% zX@+lh`PVPv$E;1IyF^onkOv8NAsnHb>JKHdCey#;+XH$qjfpf*-5bP;D$7r3TM`AGAr>yHS+zh8uJXzSurAHF55kEWH%ww9pLnUEy#c zN>JO{@4_tQs~lma3&n|S9lt-mA%fUaQ|$J%!8}#s&68=LTQn@D3Ma~>dbeKGKa*DK z*B1d4FudP|AI330;SVgxKZ-ufVPs?cPM7n!YY4l+v*!TUB=|OM$0ucfEuX4cqb)V= zudASO_GH@MbeQ?L43x8^liU5Kt`o|9u$WKd6cvnMuDUG^SIIMT-QAX_IsPS0t`_y+ zI!K!!INH8ydPm|@hq{Hwf^N&3G;X%^hz zMMyqQJ07pGWzlbC2Ey8Z^9JX$V4g_n64W$wDKjhICHu+tmv>29gzi1X^Y`6J(K}pg zRlKls2hZQ__t;hnP3dumgq|6cuY%w8Q5${#PNI14DR~1HYchpbj`;GeH}{vn(Ee?j zBUDONpg{tf@BqiPv0Pm1gTYIfaSg8I^cC>zTs*9#4cw>oLyyCMn6IWTb-nFs9h8Dm zVlHy)iFb+76%>MOx5gg^+ouxPW!nQ{&i=6w}RuKeaj~ZzuA@9Z*nq)(C zz+07cXQ+KwY~EadlL*ZB)jIQ3AMxJNZf?g25pgD6Vj{;d?4-nal7_L(T@>b){Y($z z!wUYk=##-#o49WhyM9EGHjpGC6K2D?*_gbLDE53CbhiE?nbMtI+wZ{R%7z+fJE-5J zG}665P#x1u!jWXVn>g&QeeI~i093tGaQJ=mso!^_c)s?3jx#lY>=`2^ATaL+hM0&( zxAWarFwT!62FVqDTo`vXG)uC8EbRr0&w#9y#;l|ouvTuA-0gG0cU+fCaf!zlqZon(E`XzG@7hNLjQk!M5+!#x`Cu@YTa6|Ow= zk-p|54a$dq0qUrdIy4vs^uv(`4ITak(7ugnA)On~jw=A-*18KII4`2c+jw#qSB56a+sUaV%?wC=jIfpzeXRAa5kB;_ng`w1sR*c&Ks>}vvrsE8{P z16@}^xQEd*{*Kc@vS|n6K{3n%!xc+Y;O(c)3=CreRmGIq(f$tK)9umw)ZAXd z%cI3<0anN*oJu%_j6568gp;BJv=8&ih-7rfmuL(3Xkt*VP_7*X73b(pR-j336lKNE zNrj-fx(hOX$N6lPKF=9S{E;)M88P?hh=R+WX8kkkkFeLwU#*4=)3G>QhQ{tWbyPIL#^uv9SF%M}tk_9$585)*glM-vFj@CHK(jTkZ?cx?$6f}P zp2tyPS0ECEbowe6ytUgCd%(Pg=qFav?guTpXHqu!F6NUY0R zsiY^bp?(-Z7#WI*QOE29Gaz@uQrqjd9}spwM2%h&~G>g-=-qIZFzffY+|<2i1*D~r*zV| zOvg-vtv!#qu2Z4;OXjwn$e;;3@74Fa#G=f(9BbOM*)9NAQ7ThB^Yt_<9gHJbU(cV7 zUvlXX%0*|51*e~Nj3Uo~Bek}Fpqo-C>>*(B+wKi{#VjARrZ{8-nL1KBnYRfm?)`qz z3rZqOy|`}q)nogUaV!->w57=MsvG0yCTLK8DSDU*l3{-PW57+y*W2dx9PDNR?EWxC z>C}Ajwr}4&+L8~ZpOOrDTqx|H;+`2pCcp5BLgz`B|WGbKdJ5WS@>Ag7WEq07x7W$d|#B6BGhCIF})U z6%@CicolyM0y!|ZA%YdE6#_Xjmmz``6u04*6=_5PIhR3*6cv|X+!YW4H#nEEcoh`{ zFg7wam%)(%Cx5KAV|1nMwk90gc2;cLwryv{R>fAuso1V0729UTwry98uim};^yzWF z?myk<#~S0Ax+bo9&#@>-l+_qS%pFaEl8z2;3@nVyyZ}XOdsBB;RY!Y8M;>_wRiLFi z;IEzoj)FqW1!&@C?dTwG;s)deXaUUu;y^P1D=UD7hku6$jshU&=;Y;MZE58Opw>{; zqM@Us|4+?7E&x-n|FHaxbhWm008sw@@BrF5I@tpq-2OuRUk9oIfdDrvAi%=f4hRra zQr3}ClmbvoDQWI5{i{u>7LGy^*QW1_D?QTAb-Hz+SSR<#OrVFzhF)-*8eKQ-PPK` z@;@t}2e<$&O2>$A5YK&l;@VT!D5LjBqTh ze{-6-{mpG@?EuI0&#uTgSU3V$nE$OecX#>^n+MS4Ujw54XJ=^s7GYxU=wRmsFb7(| zF@GsKy8TTFp#HyOneo4m6=Xq_ro|T-n;q%nD#(V)u7u|9{eJIG6)n?5rJtf4TkFSOE+y%*_AArfy|z zX6x_|2^{}60UgZ$YX^Vn`d9r-3hIhdsxox{n*;kVN9DhZ;HK{7^tZPE(T#$m`TrFD zfe{sT^aS`YuyAq%7+ASk{=UDz1@W-5`~7cH{tJlZKV=0IHy3M9fZpG}nOXkT{eS=X z{ikH`UtlC0%pA@CSsgVu69@CZ+x9;d|Cr6(U0nW>{I3J>x9k6q|F!o(peN7_Zgt7g zj4#wCJuAbl7CUcvLR_!Emj!${%&D|Ny|^&2+Oa1fJ#vSq!uY)=jInWw_p{Aw@yzMt zK$iA!v=_^cswWkARY2fJM$=b_x_?R8!9{l%%w$-Km~pNZ<8!?rzYU?w$*g&}JE5X# z`12i#aH@mN1?KvRCXmddFc5?M(Fw`lEUi8svlFEe1g*B{?3^;`^irtxy$t|G$W<5-J-2+|XeiA}4^8rF3#$(*lnu3gj%@}}Ent?4qnoOKUQ7qhzS)XhsW6bFtUq2~kK0B1H?=2LAq) zyenK1YuMrDM+76#4N|3^K7UY`bFR!VEMN`J5X*A(E$YFUpIKN~$0nTiJmwMlRkfTw zPH2xG4=i=F5li&fq)p}A@G2y*+f8;0nI!Q+9=}4_ac|YTF-w~r09@QY}TOW zsyIfWxqB+YP+;cyifjH5tu>dAKa?2qt6szpuGk&eT#Xz&t+Cj5V??~};@2$&`)uf7 z1us;JO;DJ>b{F~zBpd{*An`$eD;ngU%7^LSnYsr*n*v3u{^!rlIaiG6#rnWl`B4*ybNkMo`34i(bP3Z zt7LwU3+j#}DF??<*2)5#`ZUpx^CdMY^>_Wl&8S_C1tM0m^>ZRt**|PQJpMjrI@W*Z9|OQs;kJO@x!6H2A%)Y?v(T z8)ts?@|oaZzrWiM(9huFtwgiU)N;^q*d?X=ubOZHrs?+U%!iAMIN=`%@=*6ERBN5j z6qaZLDF-1x1bT7EOv>!wjNqIVz_`e0=Ql^oJ()A)ky*}so)J*G>^=8T<{>TLbiP0%Z|Xn5t1*1;bOECoXs3+6N%w?Ti{pByWcD9|3c% z^4dArNGeCp1}nzWEkBOFIG%?ELB?BxI5`fJzsjw?$7O$blY4a_R5r!5Uw<&}M22~A zh=|c=v;AbclJgRxK3*&7nH69R8n~zZG9^YQ8N|X`B0CZ6iy?HG6@6L)&ojXcH6(ds zfcSaLM{;d%5_MmDl#0>6AO6w2ubw@g-LS+ykNicd z?TuE(a^buKc8;ULtI)A#(U|ONBVCxs>J!9{#F@O!C3KXdOlGHTaf9zVGwNDq;fhQ? zH#$NI{Fh=1=#qI~b7d+Ial%vk)9)YPHr2f{D>`A8QpFtbQYCPOfywk4e!&xuW&*3d zk!pXF<6zOa8e7D{H1zoaJkl+cr}G<*yal=>Ps_&69e2d-i{oM6j3|Aldj0aL0t0XkO&IS(W!vtn#aL z#TN%2uWD=#r7wMKt-FRl#TCBG#YwflZlJPlUa!nORE=R9U5bP$w(gYbL{@crQEIko z_aQbdtOCAkFpB8vVo*6DvF!Z!P~AEV2@okJ)tsgcPzJ;S`D8a<0;05?gu z>`s>3Hfw*TkCUFrWU;@N(9rZ#pLKNP={o7c{O)4w3M4!;4*(ujq(Ni z$8h3`DSUw@at+Li4HeN5P2ke-X{;|uvZ+R#%G9qVxX-^dRg~xswA13O$U*h3ekRJ@ zOXmw63ZWqG)7;@|Z`iv-A6$%e@H~>#z$I0x*!!lHV=}7v-#qfoce`6U1Xi*#AAR^+ zs|oDPKIW#5&6MNNm=hxXvP6Fh3_P9nXv;K9K86&%r^!nQc8I)?xE^_>OiW1_bzNB= z%|bv9(QH4MZBkD)7vFE!?u$JeIb;1LG!6z|{VKjlimqFq0@C{w_Di-N!6NR~ziZ%P zeNC+jNVL4s)`Itn86A(*K#f-QM^#{4rslO>+D*lqFyB(l?y^UjUKoG9Z}2TA#MofP zYV^@8f{qO72S#!o%`;NIY;b-HiW-meiN=Jka#o{|L8)Sp%{WcGhakeBcFJ4+`DPs`SdX>fbuIuTM<3@1;FYnK!#a<_H0Q}TBkixzzO_V`k_0-l@i*NH1L^gSpzNSU6d1ZH$k$P6fheCH& zj>^j(29rCad1ZfiZg8hsAkxRMI!Qzk6%7u{+>LI(gf&$O3*Q$HI){>0q z&UUKbnlmM9G-Y9!2o;Y7x<7wq3kCAz6-8sw3CK4XAIpCl|0?@%l~Zhg0ZH9M7nMcJ zK(R6*NSiB*nIud8g!(OuauIR2UfNREw5xoSS!3Ih0+u;3>f3YNy|hzSso6Pv0v)B+ zC{fAGNBkI=+j0I8nqUyX^ZBKP^^9%)^l~=CdPf2;WBsY6&T$;))n8d8d}lOJZ!S$YcKeQSIzY#cETL&UEp2v$fmiMYOnI;ck5&?JevNAAQ}!n z;n=!v+{Nv=gt<^^emS5NB76WH^U)A&eAvQiSk!+6;^R2JL$y}7(emK?ei1#h!{OIW zo_`^D*1l5kDI`(W0vzCTMR_5+v7|Fr=@>Uv9sL;QTVEsQ=ARuJL8o?*^uSbS&nVWV z)Y;}|^4XgVX@CDA=czyel2s&f}Hk|gJ zVM>2KcMCP(2j@4tb^fdX`vzr;3ET+hK9AP%c`5b6H2GgqYPJ_#Dh#cWvO#{7U8uW- z6otZ^HCXA~9$pF*i7x$+X*O)VR8P(NMvjd!1*juEQe-DbaLNr`2ZJ3cny`MR-~`5x z`$HZFdWjOlCL%6HQ3-?6AA`EN_%u=W^67s}9b7nj8ex-{QSD^@Ejl>O{pwt*`Z;IX zRKf>&$Y$pO&enct*LWk*?7#xfPw4QHpPz`GqM||>vSA3Hi(U0M?%X~l#`nTHlek-l z5XZ=FEECFfj%UW|US_bxM3%1?QP|4x8_(`KqWJz@&CYwy&UvJHJ;~)H`AC~E@6~^J z1wtpEX#5VVE`vSSE|Y#Pii*s!k6^V(If}k#~nKCF)MIqF>o!Z4~;7LI~eX*SFRQiULAtuntsHIa|{jny-G1NA2 z-=&rAY7~R>NEZkeX?#2TVrJ$hN$Y=V5sYx~L{~$GP&qHIdo`cY_TdiJ<4_CpSThWV z(1@#eiXg`Q8q9zgN-+2b?>}HM*JYa{>T8*HKS+e?bSOI^KOeF3gORPSmP96(;&frpfr4)rtWGyi^yPld4OGJ5C zR$eHlrQ0ui!TZ_SQO6(&>3N?yt>jjh5Gs>C6QeyDhCQ^@yPTKPP>ZhZ#)))E;8H?f zzMFN4KFhVee}iL0+byMD%|nyU_j9NGTV&o3cFK(^Yea=z=!t&9sbqh_XitOt<=_d! zGUBVa@+;u2)Y2VGqX|ShD!CQ-IJXFeq6S;leICR;+3<$q=My5U&7Oh z&&bi+zdv$c#coR;(10OgJfj6ZcQCZde#OL@orRs4pW(zxw95c9Wqywn*EfRt~K991edC;=}3KR zC-B2HNXyMl|6Tf{GjqtYB+n>qCnqUppwtydlK4Jlv%jmxz-$18>8eWor5$RfG*UU` zs=LX3r28{)VgY}g;|mmt=X3@{+6O~v2RjA-F+!=3xts(3LjUR000r;phsPAO{_^JM z*yOSvtc$*+_GC@A>wAV_Q{0qbUEf19FxrX|dqmB$IJU2pyqdl&l^!~i?9YrTs1MV{a`<#0H9c87D8gQLZET7 z!*sjuMvrtS3}NV(AOR-R>?Yo&bjMw@kpU!Mzg+&^egA{kE07rUiB`)=)Afkz<54|N zl)a_$i(h{$#>@;^*lJzE3`!+-xYQYm#N&&w%@%ztCXs|t#nfW~L6?I+-n zXMV(#IjljVe-wPeH%D0UeTTL9wwU8O7QFb%ls?LPuJ8LeUf)z^Tp7$|4OR!uKp;Gl z=+A$!lit?QFBRw;yJ#jDI!przQGZ(Mu15t#yx#>+EF6Y(#pnq~a~F@NXi{EYjJpRo zv=bA=-2QTy99u_q=cW6f+rSf9OmOUL4<`qe@zfJd0`t4Cc5E($PrgP&XB{$dBA>Au zX1vp2tvO+(z3hV&21AluhqVXsfVO04&%1w&&~UWnClY5qJ!yYWh`{8=u3Cv)MCHzj zkJFm4Ff$|KMf*=42TR1<>EFn^@8sS*h++Bt>L8XNXjLtJ1tx=5TM<1{LAv#gREtqL zdSRbhDSmI>Qp`neQrrfYC#Ivj1Z)UB@;SC#Uje>I!n}aA9+j@nStKa_up1;~pH|4^9{ee`&n;bVF`5Xp>g9EW%w`Lq z%{Xm2PvvgAHb-Exi?<@nyOH0XsOx`@Mpfl|7GVG>5c3;5HAxZwj8Q6XzXDkuHz(5T zwPCF0+HmX}V3DvKjo#B1i^5l}iP8-4FW?hqx@!C!a5-oRPua8%#>D`8#{F4Ywn6HL zpyO9osr5Cnu3HZXAZAg~0z%8iF6^u58GHYH@K>DH{N0+;FRVvA;V^m)%c6g!p_neQ zMo<$`E|$qvd>2+K*+E6-dXwUDadz7$515~~O5e;@!z}~PH@EE@8)nZ8WWJ#oUkI6s zL@-NA6Z1W5@WPoPCAD7)k4Gu5XDnYpLSzXb0ROU-HW;rY6lr8%z@9jLpKxgFs5HZy;Fbv)D)gpb4|M3Jp?!6c4!q@(Mas#Q}zTmgPQk@+Fn zfAAvF6+BrbPIF%A+SysRe@hrbPEXya0vzWLtD=|4Uh z&26F_)x^PPPF*o{fur??%s5~E(UE;@k4g|5%oMXXWS-(-p6PuLjE8^pax?N$+2S3> z7KRbF{H2tXn%qQCLMaeO>3F-mtS6&DW?C4N8BEVEp14L;C3eh4ESX{WE7vEB(86SEjKUW;ScG5VFHd{Pp~l zTC_Sf8uo_|0t}p<*8VrjVA(K_GA$p~PyeUOj6pqV`@BW`@Wf+n2#9U$&W0z-6oGQ3 zwIZt*h%nosk$#3D(VIgn0!c(Ni#Ss0j3hnGbSBX$_st}gCKi9qxrGtgO!TNOA}GK^ zz+L(zzTZc$R_1CA-db-&e%EIY)+L*Go?D-AK;s_LKn0wi9MAQd$Du!*@$O~rhg_it zO9%0ErTWr1Z;sB+#!UzUSa+dtjvQsS0n{=!$naWMyU~uROhu>Y6x?aNS4n;~Y!jQn z9?_#~`A7Wz$|--j6Q{)w5tB*xqs=g)8Lg%i!1GwkRXHAm0fD{9lK)B9(PLYhtycI- zdMQ$YslI+2Yku(+qPC??JKY_)t;uop^i7=S;k^p6)HOp3M5 zxNFbWlkS4d&etoQJ!5P5hbcaWurk?CxfNdjAa&c--V~FmtwjV|#O3+a`^|MUAU{&n zknW>J6FPsOc{j^Cn?Pdmv(NMUesl46>5yL;@(OS1w9-^aT}qxL0%chJ(9-c0M$fb^ zgl1iZ)EN;Q2w5pMwowK?%6tYLHPoHVT=b(sbp$r*66ZiGswTb)V;{L4peM}YdJF`P zh%!m`3;hw_draMS(1vtaM3ei?e}?TT?7*q3$NYZ=c41F;2%DxeJJdQkV!cW?bl(4< z1@$`JK1@elr=afz0!UrKW#@7bxjPZb?1?(qweyD4RB8I<rC{x_ZT9Kb zX2%wWD(nvB!1h@%?1O?+(sM*x3w70+P&VpJ*Mq~p_YTXzZk?tFbtN4MGvEd*m`PWc zYJGp#X$z6 z^3~V`9?I&vUTT*DZ>UiL_~j)zo>^7^jm?Twt!i#44JCI+ahTxt%{+H zUB0v=4QBsCj5dmoX!d+%z_XIES3AW@+nniw;^wojuUISpQM?9K7r9NyP3K#X$dCw0 znZh804&5iklSq3}#GP@Tfs5+a$Rkb$fC0|Y@%BO;oDb^?af^8b`SIGWuuRQg)$f0s zYHiXgA!W9MER)$H>K1vq*sc5}E(VpkOw|P=L85vJX7?IFsA1QE&qk726zE*18Vr7e zZ>ie+jk~|DC<>&VyVT?q3%?Q=qKTY4T9q3JY5do6!}ZBi+AdVzI8J=Q$0q#?yGFa! z)&iNaEVgzVJILDsl<@yzSEND3fgkfU%BFZ_Sx&#Y?+ zwJEW$)0Y`6W;g|9Ax(c77=3WK3}X9h?ANWCSEaoB z((WwQ(>4u=`LMz@CQ=)X(L-KM_fR%C?Lt3JFDjL1wn^xZFL8BC&YwLzR|c{(518&3 zozR2=hVG#aw-swaOUbTuTxEZ8&e0}))z{0P2i@p2oE-}B@A7u?$%?i=c7xgwRF)yN z>OF+7#kWiU^c%ltV>V-58&G0uHmI4-g80X}RNl=qpqs}@V|a<52X1J-reYuogM|2r zeK;9_(0BIQGcc9F4MwtR%y|DG*k(P%=ZQo+8)fx?ZU3N<{g@2fzgB>h-LyBD9h}8VdZsNXwhFd%fI2ed!I}^=gA-5jK6L*rM4hAJTG@=d4O}~vkhM8m{f&<7Y zs+!AtsrcS^i%WhnU`HAmJF)5x2z}`mRwd*!)8M537YUw)*;RjOQv^|M`W2~99*l4v z`+lcAl}E!eh;RGUL;Mlx;idCL_y@5c&hbi{i!=MA-mmYe>02pz;)d5TyV!lbNLxoJ z`!1e=?p6)eUSWIqd~cf$6oJs$OI$PjC5Zf^#9YnZx2PpcaxOon@%A_th`7ZQ>&&HjQ6(JM8A zhHafbyYYrC#lpj`OB9$`y)cc+Rw85F*w|8gsNv|+Jtf_VJy|Owj>Ctv*%Z&P1TxG& zdHJ^gOr5-fs}NEh7Ws0ZCW znG{Y7TwVn|8AR)!1Jo(R=~yGc%ZeI%4bd4d@S~=!N)O5lRGbT;<6-_BboUw6ayWGS z0jD!xl{_v@*kA*jA#~%n{H%QxS5X21Zpnv5qMy;iI3p1ZHgJDUf`6bmbGITt?)nSejX1**i0ms<6 z2>_@ivvP`lHtqpGzBHobD?4p>Mly|o*1DRCqr8WBQ5%b}>U2tSYH-Az@ zo4YJc_Y+x5@Jl!Fb7*~bUSe1O#P!?IpX6}-wg6)`-wR!QBn{|iC6=jp&>ltVI}eEK z`t^eBWWsmm>P4!e@5$uVkXlH)wOe~R0g-=nrM-+Q5fpHfV=n{Sa5)f+exitK4VLGe z#hgj>TfG&$FJ~cQwZu~ZnG8Y18tqH|^X-sl5!qs*YS8}F8h{`LQYL_~p2his%B^U# zzXZAt@@$!Fk>rOdephc0iWB1d?gINz%9gzhgE{>CE2v?VA>zrGeq~$0_BjsNVIO}> z^=EA5&^76&%dnbh>;qSfT2{3wT*VY$t+537{3O&vQy_v53h!sQw@AjKn9*=)e;dAK ziQxM2lJWbpYq`X z?cL#$v)X8N*G-ioQYt(80M*BHboGBG_dGN`xbaTb`Jg|u$Objpa&mx~AwKnMwUK{v?{RNWBe;JpX*;kL ziK|X?oP=We5@dGN)#xa$a=Y68^diijIt+kCZDMoA8*B{@7q=o%px>XABF#X;`y*q>Iji1qj}fDqe48dXfH zo~qz%t`yf8C6AvL9IcKL>1=zs)G(qrLw}6?dZPh_&#q?tX+<=`1O=ukoljieHNK97 zpRPPftIh+z8t4k23S0775(j$ZeEDJ?lAk09>3q0{w2*xplbeEF8is!zM8$*a9u@&7 z)w1a*RGsieg6v={kO;;?0jdht*BcMs9qw7kNWE#xjKX1kdc9d*g^>?rT>@VFnk5c5 z=FPe=_9d(_ZCvFL8(SPO?tbdeqMQL*db70|aV2_U0b|_{cYjKwL=L*%A7_Ds3rDr^ z&r03q)H-fxYPgXpIjVnZ$+kkT=l5xdCV^8}=O(HOu&( z!BCzLtv)pLcaihlgM^VkeuNPPCRLB;LCv8eu6-{W+bM#f%lLoBpshyJDM<@ofwJ&* zXcJzN=Sx7c+j5(9ajp^lCZyg4Z^E3cBZ9SaMZt`<#0pj13A1UDUh!N#7e0FC0oQou z)E{hCbyQ$HQl-~qIvjM>0zLTbedlrFrEh2A1aq{;{_a+H8p0fXe1EIYNi3f~9@RcZ zKXNIz=F;JAl6ZgcunlA77za;Z>48lMfdRnFlsB8313+V)QI3nFP30K6UqSNwNuV8M zo5vJG-p-{+3xyGEaE)9B$3)tEmk`g~1hd5CpRAhssbd?#p{*3b_DAFi76-VS873KF~~{9w4~dlZUYu^yIk`NEK8isCAw_ zQgst!xaB$|ZO01&1!Ehg!=p@`*(jUcd?mu9zUAI<@jalrK6Uk0lOR7<3Xs;}p$S8@ z2ympP!o`1=--`M0UCTQ*&6iZIvD*j$Q86f*fYaEofX>#A*IfP7A6v!d#&S~m0oR)) z?#T?LT80>rZa3|Kv4Foik!}N`94@0E%i$*Mt@auAJY<7`k~>P2z(ES(OTS<-kqeVM zCQxO?)0D>T5XN}XO~j(j-il&WhEpN&{iJpomi>Pu0onw zrM5>sY~fOvpDzUcNZZBTxW2E<0%E-HU2JbEJfsfDJjsHwj$Uyj!V!E+cV;*#+0gI- zYT8+_MUVyx+sRT{S}J4rl!39~>1{EnymY6FcafAbruD$sEFaItuN~s-c)>$wyGP02 zl@fp6${BD49jD)-kq7Kw$v0PR*K&)H%a5e$%akwUDqD{Eo?4`I z09j?1JTJ@O;4I;zsca=}7xzPJobw_=ZA|^yadg&FYZBP?3TDHizc%9_5w@1R?2eIs zGFn`8vPa~@0cr=51RZ-%0*`hwqYZx*{IHp^>9u--Q0~$K7>vtVNZ}>#GIdwf9a@i6 zEmw3lnX1)`u5+p)*v{~Mv6k0Q3%L|R02le()JYH0?_5*@Zw!*i4QA~(+r#7NFJ%M0ML12F$J~q_# z^`+tx9qOrpA^CmJZ+t0K8lm6&a2K;VacwQY-8s=+pEGppE7&?ao{Rp9Gs#%YgDhyI zs=(m<)J*3phiv3fv5Az4TX9q2b7_6S)Lv{vx_SM{J4d*5dG+NkR`bScu4PX9hC&>1 zMe;p4{kifKYhXX*_>dyX8svXEjoWL>U~a>4dXXmYB{V;}o%o&l7d)l$pxB%k0ECBm zGC0rGr21J|b8FtzX1f-;?f~lH0W0>aZhy?(D+Kp0r|fs?9e&CMO|-mzI*hQi<|%FI z{!(h2pIt1Tf1Z5(RAg{u&c?Q=Pl=sDI@()KYH&;R+%QV6fT~Kj)DC|#jj)y4O39K) zGFxt2TG&-BPVg8veR9k#(6QVbvYe}^hV+alEuPTHNSU#s4r9%J$CxFy81}+n@bajf z{RsHHfZ)dYFopTG&APqm?^8|yS?AAwg&M$ojAm|{_OjlY7>*fCRFP@i|8YC-juC=# ze~}b+t*MkF3+OnK{{v67H zvV`)|8uK2E&s< zP1zeYbS_JZNq;z+?;V8R!3}OsWI>-ig^eoUTlF6#oA&Q~hW@acQEF;4s;g=)M;`&2 zBx5$;Or$JR9;koAhQQm|bfG^bOlyI(W)i~}=%|GN6e)y{_x)WMG^9hXTuSO5FTeOg z5xNdn2>;;&;}_)tzEJ350;`&Q<)D@PpcsYl#GTMq7NKODPv=RH(<(fI3V311iB~8r zi2Fo-DfzfVt`i@u6m>O84TvE)ah5@!wL((cSYCKaJbA000v&KBfP*ej zqgMeg+=SmNIH4G4e`L1$rut}^n;fYj3Z1mrSPPtT7_rhhlC7Y9#A@`T#>5g??s8G` z!RvS_3z~oOQwkdb-RW1#H+BaM(T7x&5v#fszpiB7=AHVy8u}h{V|Bq*v#vnGJy#|3 z>|ltSp}A8>@y)o&JIEv}X{_G`+l00!fv4mrQF{fID-BxJy-)|y;;Ngl86OJHQz((V zP-OFx$fM8g^iId?$t0x-y9H~ue5(VZnXola za&nN@Q?=E`F-$|>@7lQvgOFmlC+&K8YbrC=vXL=FO?dDXWvXF9PlRWb9mwE!HsLeX z=XJLCP?;#`I4W=(LvgU6{Z}MN^wsh>HaUyqX1`xX+@l08s)a`Q&lFVH%30a1-juff zI1_&}E~!2THNVRt+C!jFPAwTvU{uAGZrYZrgPL!iB$$6F9d45j2Y=&?Ar!VQ!@!qXcqs<0%iCjsX&kRn5}xM8^j!@n9?Xc<9}}DF?SG*cSA4V#bY65`{rO zEq6r?)gA~4-441*mgz%Ec(JZf9@RN_+{_WsguHhl4)bPrQ^%9&L@pkR=%B`q7PNoj zt7_mc_#fPMaSDv_5d(S zpZ5{TB!2MY-S5bwE86+dE#fax%ALQwG^AfpSL3dA?e4eXD(zmbUvn8X^gI*vq69~( zo1^{^swCvZA&(?=ITzhG!ay{tXXwRIGTULpfWYr}YDAF4EOT8&aNf9>BGP}}5$pIK zc#F`4r48EWPb>m7q^1p$Jr5mHvs7QyQ4_$N{vr;>M1@Q+K1miUN+xn+X%+KWOz39- zdw#~of@XQ>D0%Nmg*@ZaE{fvq_ZxLZJKKYpuckU5SS2nbCktOJ_eF?r_-WpoHv+SO z3ZVcoN3HymL5r)AKAPNhxwn5)o%x}b3PwYuJ_?NFs{w+hj&;o%y#-OFEe5$cM z5AQMS?G@l>5Kzg#P#a80>0Wy_KAZlM+ttYdR#)?!eKp?5gIEoKE6Y zsYx#6fsezvrCSrO36utaI+HK1A`nEf_n1l8{hYJ6z#&wXE2sVCGID5CJg_{lDFxdh zB3Pzec-f=W5JBv%hjo8}eaBPoU2l*e^BK%m7aDPP4%)0t1~Ooy9~kE>sZh>|^z5Ct z#kX&SJD;&b31-yN;3guM(dG+B@fbfs5c{ZZTflL%lum>lE8r6sVf}G$P-Rc?r)>GH z*DDW7!ejPV_0^4Z!>sCcxOIsz3bBc-snxoIJ6oy?I!ZX{ex84z&)o(48e~pMf?csu zZ+8qN4ht?GF|txNPBTZE`p&T_2_3))ORx1BP{3?*B&aIKX2DP2NFYS$O;pAXO^pUQ zTI=lT>SO~Yzx)0Q&w+*KtON}nIe53w3p5s81pLF@2!Hmtc0*taw^e#6InTkA$v;1u9SD4gn(D5N{m{($!0Dx!Y;JY0lAgLC z`M}vq!PEq&=w(t6qW7|iACH0EK+K9ge20j%*w{?7r zT!b@X7n;?WZNa}K= z9-<7Ed~#``-Y19xIM;-!{M-6egU4Yk^K~C>9G!0N=6;eRR*P^4CK(|bq7TF-cHIRV zk9vOw*U!@_w?th5mKf_Ti&3a;F_b*_%4@l?q2FutB||3W4&Z6m-~4EC?;nVSSX=uW z&XW>kT?*ldeb;Cu@?a)8u#!(W@)xsUVHIu2e#Xi@@}Ln7PAx-1o1IP6wRsbUpY~c)o#nHedT|9z&+OXcLq(Wi*0x~><=SdtN9w0>+wK_ z3md&$F|I2$9HE1T$0UIczil-Y??~?P6<})JuiLB%MPEh!9JmO^cpH#6afB7KAlm81 zZ#HEpB*=d>L+|oKGDBk*wz{@k&h&Tvqka4#y>x^nKi%ZE0g7h118!))8}u;+Mpb_( z)|OqIMp}WlF9k0r#uk~P4>KsaxHJ*NJ4TIX)df@(bNe6q2^veS=1$Bbp=G_h#Q2RsnOj6NA1!rwnX1x zp@bF+F~kv_7gXUKQ+i#NZ3eY?SPOp#@beIY^b(T1l+KKhxn!;h{Fg~f9rjrKbkzFw(yB$mUS=@Mq>P2?>TN*+CkB7IJ27c~3f(_cfOMESGnXl;rEq<-1@(n#$@Jo-$f=@B zgU?|_V5j^d!L?S(dM`g^FI~()Wdmb^a1-_2uM~H$@koCw2jAYQ)Co!H zM7TP>tCVTgL-Tgl8~Z3i2%k=5-gJdCp@RtyKq(X-|MoFPI^2;srdH4LUpU7n8 zB0T2Y26mHaDJxV$Q(Ta_u*lx-UZaZ5B&E%~ty%d$W(_4brbj4NADcuDLP(-ES}~Jn ze~GI29eeldj|J%lX(WFjsfj-}mJD9JY?qqaDp@ZsBL4CWIsg0$w0FKir!cyHW3ME? zjjF=8A;yL)Ut}3Dm5LD4Ph;f5?M6&xUb4!Ag+$eU*vOXqJlq+>Mm~hPDURVmmAhxc zdB;-0xZSdogZj~s-#i)$;q!z}`=(k>Op+=H?j8SDTo*d*X=#7FG-j3&?x*Db4zciQ zIU`rHbFV1Kb_Rv~iI&(BGw#Ep*Qi6U{2ey$VJqc&6M7mD`_f@kz1T3&YCn}Im&Z;r zNisg&cFu7wmsEU!fJFB_Mu^mYWxZHQZ_ogVS9vP5k^hw9RXeniT(St5iJ|RmGvAg5EpIz z!k||a2l}S0jnX7QkS~tI!<$SMBdGQ`KgO<~UGCtOmtB96Fp~?{FR*uGbg!Lxhc5EM z)BLuhd3wovM3-zpAe}own#QLF>cXGsPXZV5oQ8r*(lWHgbF-B%AY`NT7Pb#i<}~BE@1!g|+;>m92PpwF^M|u2 z?9)=t>;`{|AR+kXMdhAfgWZ`ElbR<`i{LO+y_?{7yNada{iEwPy1$dvhnMHfZo9A+b1*ZsYhns&d78RtW@@N-Y&^O6tu1hdc+T846pN;+M)v{=VMKDdeYf zsPl+Iq8UM}vXhvO4f|^8AGWm}swgFBb4o}2tF*CK+xm|xH)FXSdDu9&78_{tahxo_y9~VAAK2dt{ zSt|fabRUbbU-&CUL~(1?Ab{Un@JVAsp6Wf$Na`X%)O z?}Jgm`5?R({Jr0tg-onk5#_GnV#|cFgPr|FD6Jq0caH;`K*^Z;82zqk7UVOVZE_wYrF4aPnSzN zABa#|=*kIPrf)rv_8$PNW+GdR!Is|xUARA6J5OP;L0c?|DaLUT!*8qeZH_Su8D7zE^$x7_MgsC`(XuAWYe3)_ zqLFQF)43pX@+`1~PDblR2tR3N6n%7+rAk4{a)&jt9%I7+2V;cyn<5+|^PM_7Ii3D3 zya==l?{jcb;jU55eEk>8VsW*$eljPb7wuMq-0lciP;X$^2c}^P$xMGixB;`N(XVvA z`(%-R+wMSz8fr9MNPov#*A)kR8Lup&S5=>wnNfDUex_YUJgI|DCGU30-%o9;!+_%Z z9&a{VE*zMRUKK2=7rQyn#AZYg@EK2)WY>VZ`Ug^*0_vUqKx{lsqzP2g99wy4OF@Z; zod~{$hE2gp zxJzF@;`c!jl=S_pS+K^E_tB?m5H*X|@n|k_r$tTM(r{mu6|?KVASNZ^2(MYZ`KJWC zN(D+X4{7iTD3(S(iNO= zK+VKWhy`#>pE8N`{E%YZO6-MX0+IsIsN6eezd`?K5-r}T@l>Fv(`1L&r#JG+~@i@n@Fz= z-Kl&WAc6&94+kCksjnPu*B2h_m5M;{4f6w_cu&aIti)y{e`}h-9m*yHHN{oMwM;6o z&9%fSyoH-MX2l3nZe~L9ag13Md+?9wVKh}WXR@h@;1HAN-lrk;M|STfHWlj$hwX!* zJGW*4%ou-)zEy~PBtljNYiax^-dXQ<KgFhzLTT#rD+mxM!=<>?MER~ z%z~QLk-!1OH?lEM#it#Lzpy{u(l)*Yq`LDUL@CjdBA9>tWvEmcV`a zfV)p2U0@i;r3Rr;tE1E7Ds7LyXAVf&M`#Jv4+?*o^RY2L8JC;}Y1HwEqWGlY-!{{5 zUUwdoS!LZ=^-#Mw(Ow8SH890Yg<(u%!?|qau{iRS+V81v3M?h5=i{mehg{9rFC44w zT8AClrZI)d$1_6TB};kxV0p&Jt}W_o8BY5Sr|?4HNB_@E`U<3B7DBtlZR zp|Xcyqwh)%>Hw+Fi5KY?V3@m14vrsH&C*g`bOv&cCvD z>=R0MS{)T*?2duIBtQM06jf(9e0fF@O5&mt@rfx%m_{U$6T`N+vt=hC+>k2F&q#l3 z<+HP3#-PY4Fe!%I=vndfiopNQ+2y)-vbja4Sa1*A*tx)6mAE6%@9MiP?Bs{6dp(CI z>!W+v&}L#s3S1UvJ6Ih0(>xtqH&XfAR-|_mcBGds%yMw%EYnsVyuWr8JKq^QazswxLV|){XU&6D(&P2o^ABB^0ywnLOQJSEXc%_o{ERRt$#&i)pMzzo}io z<1aiHP~Ya2DvE@$?GKMJ3`T?_aU@WFS^LA`(VO#~4|!udeA#>pbkPG~vs|mCv@0Or z7=Wfm$Q)=5+8J|e;~DZ4$pomoK`Ocx>l~I%yY4zG1W9XgU+o)m^@;x@2!w2ZB%kG1 z9-^0}_zU0kT3nnm7ZuxnD_UdZ%B>h}3+1qosjM_TuyKMarL!YB$5b{5RfQhxnB2)0 zKAk5NjF)PXTN0Ga5N?C<9r+U=>tGCF%>1T2a(BEADMBxp$ixh(sEC9aL-Qy#DM6H zruUhSGQ$2doit`N(wa6U0?9h)g=ZK60e!aA6L1*r3Os+8&P!37w#buyO!Y z{Wv1CiCcg6MQ= z{Vml?Y3AljEizbJC+hVD?S}yn z+Aq;2ArTt$Jw`z&icYV)Ep%#&JYqVWH^%`Gf8GY1*nC=lkPo%Mb2kK9{nmWHmHgDg z;)ClsDa*u-J|{f6#IHs+n6RDBE#uR{N@&d~-6dN-mY{taXIdCrF*0x5Xb2Ce5^csg z!oZhxw#&D~J(dG%Ndc{uiV#JxQ0& zLyS(U7%D}7_VietctR#VX<_ba%N8Vek?e8qUK!f2*S%~W!KHC*0DJ2;ca#I*W=rY9 zp;M7z>x{S>H)1SvYo-GavN0QPs5h&ralv?U?NnzrW`k3SEsS$qFwiV?BQA1mwv1qo zN8RGjma2#vf0e34VT%Y6;EBtD37qPV&rV3Lq~uM1(zBn+6pQ9>E_DDzU7DbB-VK84 zN*Oaeu?MYoosezoSDneMT|bE7FuBvI0zXXo|ECBChWyWVPY}T7jlGxgQCFchQc&C5 zLU6DC9Jz&%;V%0@@`szzs3n~VcKa&PwK|ir?nN5jDB#2*#x!cal7a)OcQ0pzl{LW) zE6c5aSU=~4&1tz9#az4>rPcq56M5nh-QdIgm{lMlA}Kp6AqExYHh`#||rBpTm#uTv_T>HL;8lhf44=3wp>)V+Q0i&Zq>D)X!69Ref*p4a0Ehs z>E#tk0C|D5RvVN+8xjrj9n1CL&xS>s zpQlfiMw{69gSor3KdTeqgD@W9@nrPY^f76JSB%3@gUKW*A^Z4h{MatJA94@Tg*_Y@7r3yaRv#g>L9CKP=)ap!sbfFXB8^y}Yh2{%1NDJYu()+fC5SxcA{N-%U z6@qvrLHsac;sSXj+>Ve=(l(MRWbRe#%U%3Cxrd6gkYs@diU6zyLS^uR(7esFB5TvO zc>4`>w(pKfEqtsF1MNU=9L#50N)Slw)E=Za2*BB63}vF_Jj*d*Or{RPJIwZfXN4=$ z*vV<5_(C(&79jUM^1bJho zfc?O93TIp9P|9iWpRNYA{1L{ zA7=vuh>N~n()U`-!K9i(T&hM~J=9m74%mu8R%eu)`<)jpw9el#*uZ^==>2Bi>xETa z9`v61soM-hdf@|^!>?|~E%ne7*B+q}zxaJOX=Mh!_PJu|pU1j?MaP2armi<5 z?zYj(&T=di`~+pl5(V~4ZrJN!c)$UDMkrcSoG2025?U}W1#~9yOQ}Cyb#^qavcr-6 z($b(WaqW(X`Iu4w_GU9&&J*^!K5tInU z=yB@gn`20$hWCNGjYn2;;&Gzr;CULPmUSx8TdGC;Tr&ii^X%UkX#~oPrF3 z8JU=Q!MzvGf?r-J(He8_<(nwOQlte0bz>1|n|?40?$LdGcX^G>biCpx1~~8x{W{&b zVL{UheomBiyeza1HdnRbq{t4^r_G@YF%DBC>ZGvE1gZiO>+?Q;$BI&lxKBCd4%@0u z4dpUWL97U~f6Fk>G}FDsDJtMt=$;vd9qzt1)GaUam^?rF4v>^6qB#>NzfW_HBKN)2 z5hvwZuB}zy1Aa6a0)=d?AoNph$hzTDEuBxI1(zAUg_w9(7`qZ{P~IXC!@9b|f_#b) zgb2-aUOCk+)O-1Vm%c*UY%gE>T1QUMt0b+tY3(u4$k-0C?(>#jfQxTcA#r2j7{a4~ zAp~8(oR!Hb;y6Bnnmv6BI@65ckokOmoLWDQg{xzC;ILH0&ZwA3E2yWJ?{7QpYHo(@3B{AGLx)i zWt=q*IkA!|y|9^siMfP>y(>L40}~HG0cdC9=AztQ`e`WwNb5j5d3xJuMn;VWCAnM@g z-e*ynV&4uAFm#_=K z7~tY)ZVLQsX6|Wf?)VQx2XHiZwgbAj{QU+1T>zHO#`dm%_rTQw0JJx?bu;@XfWLAJ zhkpg+=^~#{^Q#P_!kB^Sp3yAb1-%L zC#8R3e`)@ruEs!ne;0tOxu@$tzD&#kWqpaVFY zTN*o?*_yk!{H6KJ{m<_FXP$unEqh}}M_aFdSv&ko>wm=nbagSewP1i_X8G&W)b+1# zOQ1a*<3If(ZExWKU}pNa+|14KKQMQ5=YMSw)jvH${Wl0>e=`SrTQ7i_xdj}ff`jW{ zmjJ5&yDBsM_Z9iSp~U|!1^#a-@BdqI|7(r@w?q8@dY=C)wS=3kt%9-L-v;>ioB{kD zG{*LTzq1A)2l!{$*cv+n{uwwx)BlgDu^rIX>;Gi@U$r&O{~h)JcR z{*UKBSNi{jM%>=i!R((tQgt=9H~ZUq|4Z->Z0hFh{I}x&ng)L}|Bv;*4uQG3r@1NI z+OmTwZ>V)fcBX4RcK*nenC?IyGx$iDV|kNWNl{>}LvKJvTilJPTIp@MuT$1%yZ3HpX)`rZ3rC>CXK`0 zDP5U1P-6+i2&Pk$(f#z#kn zdv7885AbR85@5-Bjj{bx&xli8y^Ne6noK_-e_!1>-QYbCeb6&M+(?7$NirNn8@%UV zSOTfK%I`y_^+eKLn%1nEnY^z@9;`(9NdXZAVeeU-zCjZ8r17TVcQ+^p1H6yOOa!T0 zv@+^hJ?>h8k4>v-h`thxRIFJS(w=w51)9cMY*uZ&66;hd8-&^Ls((b>lv_^%@G!m? zf99^ZPK^}K_Qny_HOlrkmD-C_CY`)}hbkK1#_~9kD)W^eRr>|QifS85j^>?||9VRD z=fYV;rB>B~QQ)j$qll@j%6cvK&ilR5ic`veS_R`LdLjC}pTUrHHK_0CE#p%gb8Bsp zn8|(bvFKJ0PDS22$81;)2iR3|9v_X+e_N{Z!{I4}W_;XDZP_j?$`U{?$w$0?_Cc;P zQ=sgf0sBm}UBINO2^+gpFDoPpA-)O88UaDgejAX$Y6t83q zBc?O}OScUNlWiML+vgYIOTx0)hX4<35q>>Ruc^NYlC;8kD4(Y8rW2?M#%?Yme?K^U zbYAU`NRq4c)y}UTMiqLVfqQAnv~M`s2v~d^23^7+k*7Mk^B_mGOD!i7JrDhqpwVjO zG1GRVVnhA4eK39xjw=ij1c6?+C#7g!@*arXcwmcE?-P}ZL(>A+GiWWUtMA%cG2h9} ztBU%)8gr+oOUdO|1i4~5Wc*8Re{GQpDC5owiD(b)YMSdsdp(I-F!AKcl6s34xnUS$ zp9=K4L%De>7zttPz5#E60Q2p}aV!T@p7DQci{y(e<-Lk4+o?7 zs@v;keh#Oyn8?6dQrnts|2HMdC)`L8i@76nIFV;O+fTFt57e}Aj-63AtV&S)P} zg~LC@p;b(6&WO%8u(D_OqJxm@3;1RG@;hK!mTT0%4WFQ#$P=|(7lPoba!kw=|OB=SK}k2 zdyfSfjTk?F(S|Jce?cMIu1$Y73k3K2t?pTT_~UU|L(4t9|H z7L>ICmMR$bB;*8O&x5S*ZLF*38@ET?y2?MMcV|`xn)F>gtm$U&4XHcg|PDS@(&Ye_7^x-n(Q75kfgOJUhLFSUhML zYY+IxeF|Jx*hlkj@2nOC2~*c5@urO6MEHyT9!Vs(1B5kZ-7y$CVq}p|=f?{wHk_~} z7F59~ey=@%U|aqyGjQ{Oz!h&|NSQ>XQdXTKJEwztXnzoI9vDVha0nmMhfItFO z6O9qWf0*Ds>mt(#Q_+TQYy8LR&`1$Q?QZj!RIV*l3<#ys%8trT1KL8P^5T|`X;WWo#yovP4*ZY-Eq5>Mv_>^Yr7EE{ z?(qSDt&X+>cNoa{;g5#Z#oyj7xho7kLFdv1VDv2oDWqb}7m8aPS(=`n=bZ;xc$7V$ z@`|%S_pv`U*2(! zh#Qa{DnXDeGtrFK(}msCQ)>-&oKZi<3u?UXETSYj({Q_rM22V#Qci)50Q_n@;^*Ep z41!@zyOIo4sB9y=Z{c+HvXQ0S!kCU~GU0b0h*_0x1=nUc!6!3dae2G47vv8Vf9RAU z8H$}6Wgv7DnK?YS`z#F7vPd}D-U93hEmhk3zFKH~L^wWLBlD1Sx77-S%PrP_vWDPa z!22>V`{p(^Cq_4CxZkIfe!lbFwP&!!m9#KE&J|&a3^OF9>@G7f#M-i;INC0n()8YEk6r~QVkdvI(x zNvu|zN!0^_c$cg9a4EkVResaX6(&Yug$7B$=L?M#kGe*fjX1{uq%S`JCb(}nFV;@u zz}LKmeAOCd!4z^#{kY)F{PwHbEA@{3p2p-(SUu(b8y!T7X>HJx>fW^(sYeug@9;RH_U`;)D?R_EH*t4 zCR=i?zD}?$Nc^O_1Ak*om>SwC;Q_=8Pq2+NGIG$Am>Q6{(H6DD^eW!X@NuOm7{ypP z6G~ZkXY`~eO}Ble270^`e>G)ivJ&eP{Ssds#3=jK-*cY4!VYYbQTKZrF);RYT<@>> zf7ZAO($k1{$eNm{sELY&Z7WmQGe?hv@& zH>p(M@-d_~a|qLsap1^CPKbsD;`vx2+eF31Rf>;T%6YxjFsomnp^CF!yG+A;`*`Z{ z_M|!>hAqD(-AjuwEanuKX`UM7ltghYdGTjq*o=!eWe|$vyRHyG@h)sgy=*Hb2 zN)8jS9W0x`OcMPar?fYhVHGOB-mk)IX<>^`&(x<1yG-srI^IT6Z5>mTO@=v4jlPUH z3`!u#z8nTY+#S@+!RNt=pD#|y`%Hd2HM4^r^${n-rK=`6!9doy$L2A)~N-66eN)I$e zbk1OEGZbw~a1Jf|5`;SZy%#_8+84P{n_H(;P?Lwwb)$aCxh_G#c2##_=!dv;Z$h$L z!`6Kt%=&%8SoX2J#ZB#O&`E5yAo7BFGxqQ#4J|=We}4uGqk`)P4?n~PBtGMb*>8<7 zHhz@yBf9X&tYf<CgNq#6W|(8a?uB+8bAd=xU`k{>Kh^8@ z7tvLie}^kOs4E&#WBsdH0O2eLajSz6uGnLDMA zOUaaXPLvO4Sb$%l`Q|T}9}JycFzrL%CamE%Cdv%nN~?47#q2_^mdcjsOWiKgXV9Jq z$J(x}@MpN!I$U3vBZ+2EIt4ChII6ruohgW!HPSu(;QcV_B8S+V{I)wX$ZsjL+$QJa ze-y~UPaIB&vn8dttaPf0=BtX1S~kg8)Rv}?=G0@URm$J`Jk6p4yr&HD{QIurf*Q~0 zb*tV4xP;VsYkz4zoUc{!*=IMM zqO?G`u^{2|8;HPt!n|a4yQzkXfwlx_f26gou(9D3erQ01%vX`R)#wzLj4Rm|4m}Ti zi;OtU?%i&X5Wcz8SNvMCK+*ddf6*f) zq^l{)e$MXppfdgqXvv=h#!L>X0>+^&MXU22f)|57O7hgl!ENVMu&85v&VHx{uSyFyW%`WUKda{qWdHXG0F0KAFRTaz*3osVa( zdirN%_xk*Iy)UE3A7>_Fzx7|Ke@!#3nU*)(<3Q~q78;nLUy~kODtSznBf_Y7O=3@t z+Sh=MR>*}T5<%yN2Te6TZU7xf#VA-wL?&+>tqDb39%RFDr`Ba@0@V)d1E=QH97Ud*t=GA>Su{rv=_%vIni&EsUJm*Er_ZHg? zHOV42G-*VdAF^pjW+3e$f6?s~h#SQzsV;DpQ8AQYN1TD`5><&#^?f^6^;GBF-MsK# zx@C&0?)EK_MitZ3mR1I)WhYDf}eq zEb3aYbMGhU4^6~#>Ij&92kVS8cr!mx0*i!WQp(h0?n}k$jU&V#f6_F(H5!%Wn7aFX zWd7b>iRI^iL?6l{_&nm}QDGhJ6QA;PVr*tUx5sF2`ETOMmmIN`otlw62 z{}HTsB}UC&FWv}Lf3{?Bin(A7*JmH34fn~pZ7TFjA&$Eeu?%+Diz0(H${G-Tdy88r z1!exp;mslC(P1sbX6!sI_7zh8E@dh$2ke$)RCjCOunnQDXD-05|6&q!8$ zEVT=ldJQ|$T0{$^RBm){cAA4<>R+8~7HJk7*$9k`kVDtyf5l`PL_&)^*Uv>=S?l8d zD2IjzJmU@4{;bcmyE@7piA7Ine%gDd!NDHKO(kBp0f|(tAmypI$_VZ}*&oeTSpgBO zzw>G6((D_nS%KXK{SeiBAqKSpzlf2)N2fmA4AdK|;xBj~( z{!L(9CFU55f0^-F0Kk^p^WeHjXTfjHy_)Be>nkoB_BN^p7Y`AfBS-L;4$n*HQGF`} zDp$hF^NZnVi5mT^Q%6?;f}#q7P8~W8Wjib=mU}sf#@5=d;_WN~GL;U1^Sd&7< zt|!1#NtQ4~H+AJC;V+6>=0MAB&-OPQ`6u_4Q>QZV_&6uN9Vsj96MJDK}WyObZaTj|5fI)=S4@vUax==4d*ohELor}o;kAz~+*!Uuj{&=jsk zpI4hWe?SVsyzAYIeCx=TLqOikvzzChzhhe=tXkxgN=z6nq9vWz6eC|;aLJnX&~wmA z_j!Y4K-_H)En_bi7z%lc(#gi1)0Ta6%80*QFWo{y)4f9oSK>53H^%j=XleWLlgTp`JnkTv9& z=~sELp3Yp^Afb#cBPwtJw`&|AF{4BsH9gT z-yRH+Avufqzp=qyB^6`D~P}{dke(s?MMR=jI9FQy- zbq0SY$P0}(EI#xyWjot^I|HG3;<@%vsc9cVD6_e+}Ky`vGu` zbNjzn+Ouu^;Hgvx8;j|sfE{7y((3y}Zb*;c zX!I(v=KUjX4KLaYaeCCYO@SPr;+DKy9Y)={EvV>>--eNVnU04aDOXiSL8t-gG%;z2 zIZN_Gl8&~*$R^~;-Lq9>_oSGPB5vfHvvn<@f5-NVc(kg&0mzL=-9nV z%`r_Ld@C&2X}d-sKEi1-2(bWBoeXAMyJngH_aF51fS)g}D_12rc6>;j-iqQnKyYk_ zsB%dydy{Pporoi9e{Whp@;tzAVRW0y^K+yr=@3fWla!;Qq@Gic&+?$bcJQ%)*fS^} zpp&>uOERrCi4UL9F8n8%R`C@OF%1TOtfUH3(+5&Ah)uADb;J{_B5_gPxS9~XthaBg zR%LF@lVGI66dD5d@i-Y9|8Qz5?-(ZJ;}{|t60_vCdQG#|0_zfM z)uM)*ub-oje?zGvPSK=iDko4Fz<=(D5rV-D_55ffD{S3X54#39cybawUmmUAadb)t zl7B^3GPv#gAtEK}&ja#J1s}rI9t%$&+900H@CVG=@6kf_LzL>Uk8xeX+CAH{h=(B) zs1IR86QY=Am+u!t>-2w+O)i2Tu7W_m=GK)Ee15-6e}uh{xU#sJTkQo8Y+dz;9gZWk zHBhqsY~t-}B)4ISiR&jri5{dC4?X51zMB;1rN~-3`eVj&}HWe-QRH9{|nyTa@VS$Hucny8W+g=}UtxLe0z-U)$@F! zm*xD3ivH$=qCAEA7r9Y+gD)u&ZcWOXOyWANnyv3kUB^?5IGasf-%kcul7jbWhd=6E z&T14sRCytgfU!O>BLai|fOrVJn7$|%9XbkZf6t1+T{cAXJD~;f47;?pQj*8Fi0QBk z{MOy<(*_f}65ssJ+ZGUNdyn>EW?h zil2{ja^TPB%EL3+X6$1lDu=PjHk8zgnAMSMKvxp@y4Rt|$GPWAe9u5dIJ!bGaO`&s ze-mb`l6Zix&a_s2;k^f{;-;Y6q}Wv7BrrU@Zkc}gN51l(CX&}kaNhkz2%ZqHM$x_( z!?*25Q-pkLDv$~`C-B0c#kMT_G`7=ucL;g*30$4NDi+@gQ=w-F$}<89Og5neUmRPI zBs?-@6}0kiyL7WNX4zj>14%O(w;!&@e{8tnkT(U8!E%q(pD&~2s4oIYBuJ768ZXM! zfMt}GBJefvIRk9O*!TtlVGJnbn(2>wioI9zJ9%%S-y@Y3DRNsIvGr2?%mIY<@5K7< z{?o4zgs9OWIM5rfPRFK#bJ}C-LsRa&iu6OP?8OZX@-bN76>3L*1;8a}{Oseaf5XO| z-*bs#2IiCU>Ahpvx6#TBuGo+WTZl_vUwd@Qx6=9AKFL2uss+sQ6M;aQ9!lEpB+srp z`Q}j~R?;{63)TsVUT?IBzG+A?CDCH~%6~hZ9Bhw%LbhiL`Z-sSZxyBKcp=ifGnYD} zgg~>Fk3#%1CBuQ?+o4!KsF4YFe;X01mzz-Fc1qc&;z#eILn3+eu%3uGs-H`1et+d3 z3u!ust;*|LN1S?+Pt*hX!;|bm(7}6_cRUivr{+@~uvVwXGxX>!{BdSC9%#0Ys8f3W zuGGz6xiS%^(>-!4m1N1+1W$s(UdsNKhiRqw2^z4JRx5T-?ZCBK%dzXEe>#~#C&7(T zU&HCe4$qWf?8gl3>(wo~e@a^}po%2MADTLw_L*i!7oWekBXcY-ZUrcCc2%UY6G_D` zWASS9?~Dxz;z{5)N8-Z1C}BUYxWc}_1xw?>F^ED$m+mOy-10X_Wb_0PtY%|<1J$3k zQ!SV0T$R;#v7Sl$lj3y`f7O!c>h%Bxiku?TsV0DrJ5Y^L6JtLl@_iRVI<0YRZ{hah zTq;e*mJF)Hn59((`r%v79^H;)Qp=8(Wq15pAlTOlgKAADvM(Oj@sd+l6(NdH|fI?0REN$f2n~m9=xKn=*V6>XEZ0#UlVgjD0Hlu>A*xIJOwpnMS z2@dnO8QPfP9+%XokUr>KT>MW^on4-X#d~jF3hrn^`cc?MHH%)3TRkt-e$t??%`QZ9 z2Bo7a5a-#>f3^9Cl+60TExlK+4^5KCA5$9=v6MJ>-6`6(u>rNuDm<{@4uK5Bv>Pek z5Rz6iU8{kfFO$11kL5yGV_QW^pW;jW@W=(Gl9vUl z92zYfE~Z;w&DpI)REv?y-?-B4{6LKI_1DbJeWeVae-`8EXns&BtXMUu>w#5wODr}b zmF#&`OkE=`L1C5E#n&#C!`Nm>avPT#P~hCIHj6psL65j6+(7&|(kKf#VMR~CHF`sq>zb7VDNl43Z8uA8KcMfWQ3ZA$9!op z=Aa(c(nEZ$ZqM^?)Dz4UY48w73jO+W0u(HZUr0pH^>u%md#nefd`$GW@m)=z_26Xk zr3!dQas&NY?K%ra>k6yXp@p94RT1bo{Fj`&f0Gas6a2=$mE(>*ot>x|PubKiZm-A& z3?9Na#M5r7pal}FLRG0Vs^lzPU}C?X>92kU8nRvsjs|p&e%;iyQ6Z8P9dfIn|yc1NTv0JmNHK6Wyu-?-Z zf0E=_>+_OvibigOE`_gMx6!AO=|ZZ6_a=P;V7|@h)(sgoKv6{`Q@wOkzDYl<%8Fp+ z%4g5pW%5(~A!-4ZX@S}}vGSaKXSek^?j}tT#v@XsOn1kz^Jwzp6VgPxca(|FhqFjr zEQKfCJ=5~$6KSngG4B#tYJ3{m9SY)^f8Dx6_E0?(kR${e=Ee}Y;Q{IJwlgPcz8uo~ zi)TLwfxnn-w6p$@1XIEoPs=(xF@*txhhoIl>}Y;k5YeA>IG66YcN~ET#Oi?gT*RF5#E>6z)j@}gYey+;L~03s zhcv1!aStGj5PP@G;@o$h?w%RJuG2I-w{F0t^SZd%%S6)%Hr;0A@Au>wCEB(O`r?4ko&aRsdHNSKMcci&?O&4@% zO+OMp1zT47<@S<)!C-dd2AC;9-+4Cp<}j6HKi^~k=p=15CIhf@OhUX@e~R+v*hz#8 zW8zQw5hBT;H=6t`)2g&=f5%5x^7Q3J?P$zWdw6JEbRLz4os#Ug)E{}vaTH)yB>Hou zGJK203^@Wrlx}{=UDwH0O^AW0Q#bN9QXgl(E6!rJx>tLwX```^yNrRp$cm=rGe74* zVYq^){$4V5$>F+WVSbxfN;g?(Vaa1wgE&mZTBBA#S1`*V6!NCj&zJ(nMUXkDH{G-XbHh|gu`|%b!Z}PF9 zUsoQCEfyYL>a2mXA3Z|Ej+rk@KH?=s35VF+%m^_4CkkSS!tf z<+AvvOc&Y>9{f~caco_xo#2+mnzC-ayo?cTd*qf~NiQ0x8!;5TrgFt0UE@;w4O$6m zy9`7FP92JevFHzcW^Uw=QP1KZe#M%o8gLl-Usz9quH*rb(w(KxBU~tsMNuc(O@A_A zK`7;?M+PE-;{<+Vf9OAU4T&aqP_0%Z@vg0U^`HE_d^~dn-4*ToGdTY%7N~X}oyI2p zAsvy5$Ikz|8~Wg-Q=P9W(67TRTW&jPrpxY&xk zg7_>&k&s@UPyHEXIA0`=hgPWA8xAxx!5RD^B8(l@FEh?ZQb_M8uqUCZKyDm%aa?KK zRLUT7#CxJpe`)kJ7`;(Om+uI~u%g9pDeVq)ugT{3sSa1;w9Z4BooT#Dp%sO33SOg} zIzL&*{we#bmP4%ZA`}8sLVYyurGsGtI3NGeeJ&H)cG7@Kas05&jB5&Q|&l=%iE{gVM2; z0N$pXndqGiENOEVAG*V6!fN&~@5}6*V--LtXZSNyUb=XZ zd-Yuaf74yVtC+dmQpfkCOqz84cwhw(v-XmSYFjerp?oUng41M+t5S!sv?x%2RZT79 zlSUJsxOY=jPVT?~L*1j)Q`Y^efeE12NbZNHGMr6nc%d&eU}<#@A;qV8eouCM=2h-E zyGFYBrk&7oVxlz+olH9GJ!TY$m3E!xY3dxaf4cZ~%YqPUC|Ij2=Z%#rzVzvx>j^R8 zg&Q?bXS9c&bBSTyv~Qt)Tx4w=J?vO)8hr;qAMg2sBJlk`Yc>UH~D1H z8!2(#7#ca-KsWYVq@Ye^L*@Kk$YdZ!=|(u8nPIas%MOv#G(yt5IgIbiLcH5^pIZac z=oMBx5}`l#U3+yU?-LsjgbA1!AMe(Ke@U`nlS})}dLZ$k96ps*jxN^-0a&skU1)Yl zDai|YoEz=mNPX+vBLy9s#jue3G6&Cy2R~~tq{I^M?j;ea$F%CG)?xbrC9qjmcLoJ< zIM46MiKHX}WPh4qeU-EsRN*HtzeM8j)-AViY(=WRWk?;YuXEt^`qTu@SlZCICit9VK7!dNr%!FpPM6cm0WPE4WC7@Nn-W?^q& z)TVyw&yjkFcbSO&#I#_YW_do$5){09r240T0ugVFWPHQ_5k~&?&V^6(Iw|)5hqd5N#O7bK78 z*Ux|5PCZ!5(}3a{2d@{COHu|pT-W^^%O9jph{hn=4HHf1xHauWE zAEV~-Te+CTl}*J0i6^vLQ8)NN|7gv?DI;9Y&3E)=BxZCVbS#&qB8Akcn!`F>mEod6 zr%k^6>e&oayjH%y3zJY3f9>8-si^q+gzNd_7jQP!&We4axI=#d!+h0AKi87oiCP`9 zwc=0lH^_i@>t^7KBUB;}S43ep1;Q8ZHlT3zzB^09K`^?4BCygXViSYtw&@+HKPC~? zpo!Geq-gHY+2fg)k~=&1fRJ+99v_YWRaZb<)98Mb)V8O>{%e*wf3Iou%19d_zrW#2 zZQB0^2;9hJEmPT5^P!e_3FUm#7LFzFp0z25+~`_i^hm`9qUm6J#D*xW>a68Ox-pzfi*d^hST zV)zDAuoj@n*k!hS61|fcf>AH-OKH2blplh~+zRv*Chu8?;T zFMF(_n8pGtL(H^6Z)wu17eiCpgpQ3*7Hc1PgzW@Um$80We*wE~?~^uhqzMD32WL3G zCxPZUt0I0YjRf1Yd%o<5y>J0$UtedRgTjeODx-y{;Jlz!+l|z)t}zjNEtbJQ(D=2p zj;|0m+brHhd(#BPYAcMuCMHn)>jLb1#5 zcWIaXRiFWWoambf?#U;%l)S98uENS0RO%*nAJ758q(#(6Scbd)ssu{c!7|3kcLX{K zRg|(NuLinhq){rV-Z*xPsf0%d+s}y-{&bN7la&Zq?_$>mr z1?R*X|8%0E?rQ`v-{n@dubq974kX7v5pdlt++CZ@FAI-Uh<3y_UCPh5ONd;Kk7I%U z`o2!`!5L#CrHD7-7NNfBBC1$@+E7m97SC<>rX)a{OcFN&f02Esl*{hj*S$$6f01wg zZSIbvf86aP5r4+_6g|l=O3*U0tKa|z!J#_I;G#zfWVrdBB07@!zL48u&Ic$%lpU7x z#7@tJj$A+Z_eb;kDZb7LU2ia9rsrpYyXsY|=^meS>}uWP@9#-+kRO$NDq)9`RqL?C zTEQ;6I0p7;e51VY!nVk|&TPNWb2Of$pRvQa6d#1e4EExvDFZHZ|0Gwv3g~EqT9wnj< zzV+(ZYqZm#CvKE@gb#PPo)8g!4us7K-V+Uia~rL@czH2D2T0JJ%xg4&H{v=fy_xjKtXJ;c1~e~b0E zx~nX7GozVom>mE5E5>JKSrXhaYS^&YASpV^-(QnS1$A>Oags#$1h#m4Rw6JM-oJI9 zia^ZQP*QlS%^L!|v!%lke~UCXm}?>zMc%CGe(_iF?(CY5=mwHY0q6KRQQ$*I zx>Xz+xj_6if9mbKfz1{r#lrE7a5*Rco;kK+VggY>IlRJHXAF(>Q%;n(8a^Q$1>CIS zSEM+o!_aGM?4S4D$0Fy~5=HSpgK{5$)^(x7;#7b*<#oOpKc=a#mZYLZDXqccUBXbU_pd;2wU z_^lpZ!Eh4h3=U6GeGDI)t=E=i-6*75$Y}ksdlXm#$9FEX)}-+`KCTS8c5eFlC}J^o zSio;cm?76BBAhB)C$yo+e;iP~Rt@7K*+Mod_S|0SfmirW71@Qu&2ckz%@$q_EwP&m zu9x2O>qwin_jgg|@0 z3llmFItGy*D)zIi3tLCg>AC6%e5bl~NS|9ALs+@Ihp)~bgxp`jij~rV0#+x6QOQF1ek03pVsu{-7uI40a0UYc)wVe-b3Q zgyUP%UIyDkgS(A|CSlth?0=ZIMaKF+j=^k9yR;3X z1XD#{lc+UsN{G?sh{PR*R25)= zAImF!Fr(y-)FZQ|089TkRwF8|IDA3sW(oUBEWdF{ooCKD)X^^d-G4#ET+I5)zFUm8 z&Iox9_Qf+gFCyFOzUdns+`F9B>w3=XS-Da(BK}0Gw8pv>?--q`g~HdMbH^04QXDO* z+tIyKDH83-z)l5_x{oq=sjrIS$8~McBG(P;s(_73ySyO{SfEjHD>E~dyvPk zu(KoHOTK9R1llMHcn5N5HFFyLl`E?8eVGjf_t_mc3p$q`D-xpaAWn(TxO%U|o*ln8 zhm4opM6ZEhEK*|#*L9?M#lXuQvNK!+eqIZt5{lOtwImy*Y6`RnfKXrz-Fdt=NPp1i z9tda0?NFWszJF|?4~W_@_7qc`EbUOBE!+&BCbchh{{`MKJXrk61ICV-muN8VE zujX=o643GFb|G{{cYuQ^o$g3C7$=ZsVD`!{tUY?{HC+!WC}42Hb=l)HO1Srm9Nn^R zIFEM3x2o+6^4yZN$p&vEP>|(U$zckGmyRjiqC$-0kZBud9bv1#8B21ESWs|HJF6r} zbAKeLJEIl{8FPwjGD=xI{XT)xu22psT3Te(!L?}OLAvJhU@6O#VR|Oe>cS@8jBc?e z8I@MD!%Q~|+79+RoaWsbsj+3Z?PWI{IgCslag~=bOSdWqP7!CF8-W-l&bqksJ(vBuK?Euh#}BxX(f@{ZEpN> zO$%!WbrscCRzFI$RUU2H6!F!zO&VtjY;ASh?jtR83vKSA!ks_&-JA`YcYU2%xv|$A z34-Sa0Tez&`OQo4GUfBt(ikQ9*njkiF-41z{)1bQdxaLw)8D&VV!js8106`~6tx*% z!Q-{3cj~#p4*k#x?gKlJM0Bz=h)9hr_ zRNJhsTqHuANtx}kQ@OSY_tKz=rAS*JXZz!2s5`YcvzP*((K!qR8%I{MxPMidwQNfD z_@I-6nx|L2C)B9qZ{uAtL!EKB58-f$L6mughTa}|R6&rn*JBb-;;ShLBoFw0=fUBJ z(qsP+heFlY3-lWGPFGh^0}n$X^~FdZ(uxqDd}qHW@_kx6>+aySe4e^Ta3r)Q=BnFb zb1pTVORE0VYiKv`rfO@%5Ld8#cGtPG)Z9T{safq$b-Ij=+ICV}7k zq;{lzPN0rk4v&nH@<>fpQWI->TFzFzsNtCogFuPfP<2r1MwT%B-d3ste1hYs5iyo3 zaHTskVTyUES=!+kVlP$e;=PL|p00lKhpo6>Iep=_+_ zrCn8JW~v+ei=!WwhMVh^W){?}^Bywm&ZrItH=S^mivKq{Sn;75DbmAFQEYLcGn;%a{yt3=lX+cefOwfUs zcp3RL8k=_C%zsJp30)fpf$is~g_zRu>Dg`F_1U_X&>v@-(UF`+vjm%U6AnuO1T|(MQOHQq@DK z073u{w$OKlV;iaA%BN6VSS5`a1tHe;VRHqK4I=#vZ9)C_*4dJ~85A%ff#3^bfFw~gJX(S_oU`$O(A z7=~PZV1J5cSsHEzOV?(814V{0aC~n&D@&f%LA8`eGX-YS)Eihn&v^fW$`f^sl& zQ#<}8xr2yNsEFMovsZ^svf2*y%E4&vk&wu%u$bqoXiG{YzEBA@56?J4UxMc=)67t; zD8w}HEr$EhtS}-LPkc8JqpO`E@LatJ&~nY-Fzos`CQ^2Q=jPyfgZYG5y=y2bphpwwczRECMjPWGb-;@g}k~- zH!VYnq2Y+>4`5U;Y-C|f^PvT2_&uAn*mVnVx*Km~SXm?qN=L1O+#q;4 z;yx2>n~nDEdx5DJUN6K$dNsnkJ+qNCV_9<(9Q%C#1AT!olb6Ah6BU;c4Ff0-IX4O~ zOl59obZ8(oFgG`sA(;Uwe_UyA+{Tvuu3y2A@4*mj-vA?kC9jF(IFh`?hB0VKwAABP zx7^)w?ELyUx5#1_sos=mjE9*dCRr@ja@TWj71@$f$buJA3RMWDsNf4}H5EdkxG5|u zl(vO6rcmA$LD@n}Uj#1;Z9^f1422OK1%rYSJ3?4qm>>%wsXs;)e^R=_I*lo$Dx5Hd z&`K1}SSrZE1xE!{c;!*huJA5U0nCkX~ed)1vn%%Mf0oCA>>WGGM4*8zP!ZiV3xy${3; zjS?^sN*E!-A2Yd0{(kKQd;(6== z8!;|E1%q4&dQ2P&?nn<7EDCRFNK2N;U2IS@L<4{$n6OruiOgB)NRmT0Wdk)Jp{o#$ z$&uv>LxVXoe_0c!h_>pp$?9q5U zneVXUo6~u`KNyZb@36he^t_sW-~a;tkv(TG*!~9*e{Xi!QFS&iK0u(Qf&>Kjr6LD& zsw53T+GWrJ?H&~m9~SJmV9zEelY%`i{&hXLs7h=8UHtUZ4*vapB49No+^lf2BujvI zl>}Q}mEPHHNq7uqBxJ;kqk_Hr{XNhKcIHZNWih@PjXth!2-B3d41lrC4Y@2iEN^2& zXu9<9f0fM*r7wlqVnldjY26kh8e>Z?x8T}vTWan%H`I=o4*s{fp#s--i-thFG5`ZN zH`KLZZf?kV>E#wvODjtwwh#|sqcm;{@dyWl)mw}xG-wQ4&?vYrz3SQHlW+59$MeCw zdiao?9K8~_oDB-W_8%4EC;Yd=o=(Q|=qpcwe|>~=EcXZU%!I4?XZ0eUXAB7f+uq3BXZx_kg~);b3p_ zt%x2^Q@J4F#IFWZ^hQtysK$m7EoPWF2700=#`&foQ$eLd+s34VO$C<mzwLnU_hJo(qzptMr87vd1W5CG z4N`f3j|PD>+tB6#t}se0Kug+We-Vfu&aached+>}I$#43MtKl&MYZi|0Ke>VltPa44aD0^6v zHol}C`FJK2NN3tJU2--E%c?o&^{^JI$C?jXcZjs<931tEXGiOx=4@nqTA#Bq^Rpw? zvIDGP9h)vL2+&!d^In#gcuUTn6K%K8LPkQHix*g}rn58gu$CmU{_K66V~casz8Sln zBhFZ#eUzmT@um@be-vy}B}{!;cgJIg5G7R)QIERnj1(`*ww6M7x;2-uq!(FzGu-W( zjxFUjkeze6)_wb@X4vdPL8}3(|KkU7DoydvvGkxMCK_XHl65&keXq35Ia*s1{r26q z7&M-i*QWV;M&ECi1IE&(@zrB&xdNsrFgAc4&vlE)Dy4zxf1D9n&*p+JO})tqiCdJN z6XfjCd9ie(QLw7VJaBnvC7x|Pj-})zkYgjpQxnN)fIu<9hKR~B{&?-EQ$%PQ0OUy% zNsuLdN>EP~@!nGGa#C-^=v-tC8r?c4>8mKB`Yc=1F|FXK)I#bYx3k zfW#VVvx?mKoIX4;by>@WJ<)Ex%f^p$lEu^K6-|4(f71Bd+GrYw#z+U%(^ooi6+#Dz zP0IE@ty&^|I=(}S{1JV5+jNa{8Qb2+cA{DBG;)b@!&OV!(v@hWInp)fO~!3<-`2aP zZ-+l0+VRsEL?d14h;zoVOrvd)X(CZhYqeZrZ6Kf<;P-bZ=W_r@E+sR7Y)d!AaE`MXVQ1n9LIP1}>K!|4aE=0(bJ*+u%;$sqq$2wgPtot;R1AlDp}o&yc-!Wcn2DZ=ySm(H?~Eiq~k| zpmi!o)Fvct(74Wo;v4!1bFr=Si*_=8b<`QBe@=0;K@-=J5HGs$j?NL@n`>U*_G!w# zDW~Ucp9WLYvpfvM=kbF)9>$q^T3c%Rs~Sl7z|wAq{k=u8#;gV;*2kRPfCQ>*$%G27MSCy!0y>K}QcmLEy& zx%yWgR|`ReWIY_Af1X75N?5LYfpwZ z(p;Bo*ZH$rLOc=$75l_4*d-gX|7Ih0#l~#HuGy5$f7qPeu&?Yp z`}5y5`A>(KRZ1J*M|ZynSuLC=uYZ01_IY18N7cp6XfRzWA5Of|Ze@Upm`pmxccddj zM>=|ibX+bR(-Y34>2Q3}i0BD>%AUpVR(@s&QCz=5V85{=b_}t-hTz_|q8rTS)pR)f z3>lsdrtEY&IIBk0r+HnPf6`>J__><5)hO2w&e+*-dUkX5X;ghOFE@h`^z&)>6>6H?OrfcZX*Iy)(Aeeo>&t2!755pc8&$Je)ZchGuGskI z>a?29h8LvI2`aAHHGNJU$%&W_*rG&nD9fmh%VuM%KgrtfrHm3F*6-(DT=a z`%iy;uz&dEo#4w|O6p=)2KuFsj=vC+3$xKYw;G<=jOBcV&1jd|j1sxc48|9kVo!$` zSxuA|RYfa+a$CDNf1NMNSHttg&HS1T$Mfo9IvAY~XV;^__x65XeVZ?IwufQ!o9ym% z*uA;P^xJkzclqtyDbYA^2JckW{ zg=&008j5f0EbsOaD*Ok>hHqq@vp}xN56sBqgAYGo>&D&{tZ@Jd$(aFqbpIY#-`<% z0x;=H!123C;LYJL2XB6d1dfkaiNK0l1R;^7~5ce+tEJgf9AZpL1EngKGbp;S%O;gNH;6)4LxjsXY)?sd3NY{XU+%wq2PK`Hf2?#lm>cDr^sCBXGjkK7qawO( zRfILo-5u@;Qjg;-JF9cEl$q6${7aLc)j{`<9`AQT))%iH?fv{V^6rNhvtP1R5J{t60TD2*TiJA$Gg!wA z&Ti&aX9?3;xU{&IEs3sEDwTuWy5)qw6XNatdi4C@*@NTxV0?~2kg}lK@-u9Lh1E%a(;6*XR{j!b3UAm zdraR64d4BCba-&mVS4v?G#JnSOVEbF{j#rmPPiME@ZaHnFuJ~kWmOQtc@)Iw!S(fk zjRsez=L1SD=R;Z`efq?%FNf?J|7Jrrf4!U_1-O8v%?CGFhEnfu!>*LVouKxY#|J;3 z95udqG`V^?2?x9M>*N&@LSnzGbn}%~=xpVLZt52Dg{S0UB}#RIh**wNX`iC+q5WNo zyLoD?Cr9mUH{9B0Xm=R4*;b$(g=$8|+ioqymgy$nVOY1Xu+IC#oubg;$;)R)e=m9} zUW34-;`o<5qKc)?ck8^2sAx(tHa?asC6bAQ0o)AxK6(k#g{o{Z06pW_Qi65$C3Fs8q4@j*r=Muk$z zS6WM4n0ui@PQp@tTF;J_UCXMGNxtC}sf}_WW2}uc$}oCoG~8&ywM$30e@m8~Y&<$; zR6$`?D?Z@blE~B1Z{g(<6=yh91l55egv!k6mc5AhoV|+pa$7g_=a@1WL)did)Z8Fn zLa-XoqU#nSxY~fR)R8UjMGQiXTLNM9bLJ%|g=)J%D*BD{0uVlKX)@VpN-r~*=Ka8b zs@N(D{F1We`IeL3aITb*iF87m0sJ_qqlbO@isJPzjUTbz~A0rR>faz z-g-CDLGt|!%?ULr5jYq$Wg!5pZ-?je%US(*(UyjWb@TT(#&69Z`t#FU zw3YxXv-yp@`~1Dl>i+aj^rzQ3{}gf-)2lT7{{ZPKx0MQIZe(+Gm&cP64gxtim$BFp zCjv1sm;7)7HGi#IT~8f35`DkF!tW@;Rpn1;if z^;>S+?Y1$UxtBa-+I`zq=Tx1t%iRn}140S|Rscz15d>-{JUT&+f0I%Q4O%FR!YJY^ z3CF)Vr-av*4HZxFC^Yf_$u5-T0eQoZP=MB2fMRc8!G8(I5a5*I*;=5Kmi_SnEHh9j z5G@D`Oo15A5kCreJ`A)~3y|yxjWq&*ouGBZm{JLJo*f6`=zWL;Q4q*L#ArdtE$}>gIf&z_U1VUkW zN)m-4S{0=VNm68m5cGyyIY@MPxB40-Z^!_>59A&AqW4RVm|R2#?f@IP%sdYl&8 zDURClWY3jAoDA)GB60SOG=4$Gvz|;Wn?Yh*M*n!37~t_94G4h?Ri`4n@G`{Lez50mPNb`5}g}6oiyKSp_~E zpw%2Ma)4HI1jq&)mRWF72y1x`GO%@F4nMXo%;5m7*P(=la^?!+03ARmFU~zueuf7Tc%aep?N<;YV0(?<^m#!V|Im@#xLr z$In~4N2jMC7sK?utB2q3um4=#-G`M#ynn1u_`&u4!)o`B zc(#hOfBtz52EXiI?40Zd2A}&3bjv_i_&CAWus;5$-Q(R)pBVq_tdDP7eB~D zPvGF)%bj1(2Li5#@4tg@rvm8p@!#*Ao$tQdIy&7s>L$QJOTgiTfSU@S)cW{)`+xf{ zFFtP_Uw{4W+r#Pd_VC5d-OXi>$fHUy`pHa~#Cres_q)sM+b=)A;X?d0z3@tr?>addTg z-6Qj8gPRsNC^zNeeu!*GXUDHj4jOt-l$FKinef-n+Z+1R@*gD`SZhs%{ZkDU% z|E|?j+m@mEZ40Xn^s$D@txs_O!`s*AuUmpa#GB=PkE32gL;JTVzFU5|dRT1l-hE?2 zX2JLOS3DYyzJvXn>&pl64;43RK7yvJ9rWPyBBiT~R~ml*=SCoWB9Bf~x|#%H(!EU} zackNP#LA(#MR-FQuBhXcVt-^-rRT9aHv@6Wsf%SBPK)uHB5*!lJv<{4kI}i0=Q-h1 zy1Y&Ie&}D}wa#yj0up?36SoB(nEXp@r`*$Jf`XXUzX?TBR#1=%03aR_c@URnI5p&7 z+&J*hf$}LBOqC1ad>#iR^B_NpHL)QSZ~w`S$pfp>z~zBYafWxD&3~aN$3U3EBf>mL z!H`Orq~SSGCS@tS0mngBCcKBn0j8*wlFxurId3ZGO^r~w#CSq;~WgtmpFeT7X{zWAylb4(^&xy+9#ba^|CZ1RX*j)ZLmyTUis~XCx z>`!NeTp!kE1ebq_hkud{p1N!bZ zL{$)2_0{;^JbVy~T`39_K8Fo^c)AWB!#0N*zM!S;F7G%xFI&tzgwc7KeYXNgJ&hH< zxWyvNox_aE=Y8EJ(BWg-cd)qMj6$U5H0}|jRE>kT-&Qx*w|~LMa8?rW^<+3J4Ik-- zyXfAHme;GBD}I{V-%B2*b8v|?9TMN&U;StJ#y34rC39WOan775-5p>3w~%U_!RRa< z-ma(nXvP{yG=EbKyr34cBpzoIk7f$ll>v(ksAhd(1Vk@b11beYc4h0K$;?oX+`M;XiDPs>}pVzh{jhG^H+;VG2bPM&_L>pL}y1Z0LyrRCZXsvqnuZj#bD+5*aZ|X`>l?=MB z6xBddk%4p{G7;|84HX#(X3s!SpMg}xIERx?ZL%($wsNTGg^gZNVPbDzz@iY+taYUq z_VmJ{7x+0}Q0dj>1w{zZeP7ACCj=BBU{(k-J%5Fb5+@yCszVO>smg&OgREsR(^F&m z&e0glqC(TW8{D=bm+!aC5VKcD^*;DK7%oGV?q>TFL~nl(C_b2Uvn_IfpzUX6Ax?NxilUaQ8^s*HO&Sz&46Xyzm^l>}Y#r8T3Olb|{b?y`^2cG&Wtj zv97vw`~Lz&U#0zG(|%iD)iUbxD$N+%W=>rD!b%hBX;OMDHa)iWRaHFos-tvV#3!;H zt$RHdOOHjED{@%{rK*$Z$TC)ks!yh-K`fmZn@&7}L`djGTRJheow%k5W8VJ{^UaqY zm%)=069F@q!Jq*s5IHk23NK7$ZfA68ATv2LH@U%|)BgPpz) zAPBG?XLc8`oxysOO&lx&jznvi=n5tISj>-4Rgo0C$R@oH_DEeve|2>NY`o5^Qv&s+(;LSAVA-lB6!eq zqKF3cP*;B_P(-I9f`);A(t}F_|C9w?1OK!HxdvsU;6L9|Lg^x-(bpuf;t#tuWDGU#yQpVfDWAp$UqEZgV zAu8piE&ze@UKS9Q3Sb0Lsc2LIL1`iN4aB4crpSL3T3QP!gY1DF1f)R#U*NBgU|eWp zak4^NB>^1#1yB%+c1}Zdh4xC`fLZ|jpcOF$4OP<7di>-HBO{IZ!e}G$6V%AGW3hlR zP)~w&q%kQ0COA--Vr#UxflnGjfcfAP1QS|4TR1Eme1h5NWOFbg}dSYo|4~wQytxeIi@H+GFbp#H6tc0Tq6X z*i{mBv9FY*&>^#uf`E?-`_Frr&0vk3Mht({zCMxy%%&p6g*^|+CubfTnX-aC4{i{o zf!Vah#?#pQ8haT&!fZNVn`&GrMp%3Er$62N@#p%ytqKLz6va)QL%p+ zuanS}xN+dOk+tltB`o=QYus)Uz|f@=Uo!f^ms#}1g3sZSQ4hYvlCKaFUp-3hE5xg> z;1+!u=1b*#*}<1u^d(YX9maHOV)~2LFcNVhAJqR_tjbFkf?tl?@BFX zPVgcKmbo5fo4F2UpE*6Aaj2CXtqj4sM&_cGL*AuXv}S8T<<^26svyOZFTtvi#U+L+ z2)F2q)kNlMB8HlbxtEtgVeF@a?;Al&+qFt%NRjeLXFoZ=mN9J2SG$vED$& zBQ9o^jEQqZJn-;{hPj(G?Kyum0|k#5n7c{ypQGP_eMjWW+%W3RG4DXUKA+XrGSk%q z=`L}uV;wEna%PMh`C@i_vVm_$bnDV|`%JnAt{qV=Jj7_W1164izhYaUF5Px?zXJOM ztsG5wEzF3I8CB(YZlK>0`*O<^XpVXZ<{c3)bHivihh`w%5$AF@Y5sq6ggfxtw8MK6Xe-62)h+HP1F=qcHFck6+hnpmFzke2)2Ej-+c|a}$aTW4shc$0 zIhq|(>baOFc>5Mh( zElX1|I?beh;L;f{?M{E18on!c)v5T`A70+#6#&g%{Ne7f{Zuxm7n|+jvD`kd+OI!V zr*qky@0;p>mukQIdRw@5!=5wvxhem{v~^ay-mj}K_w}{{m6lQ_DyQ8Mg{l?4KCE86 zM<}<2@nrBTB)Q(z=Pr^&1?3PX!{iBgiXhNPsuO9%XF-|UtI`Bi`S=m4bG)3P z`##oR(2MWjmFL6m#ilu2j?dM;eB4&|_4)gzT-VTWr&~N2>xtsW`h2eUoA2?CAtx%jQ$nCD&+~N~-+^1Q??8 zY4rD1)09mci^N#)sxcAQho*)cNLV^fGQ$guQl49Gngp2QWG4BrzHcs%yUTWqrHGcQ z2hGYX-psifT{w4O>7ZWbn{jrhaiQ;9a1kM1s~ms}nRfguDw8`&7@*fJmB zkL7-U`R#uo?^F*88R|_qfEQo~U=UjMCsH(mhO0B0CYmh5_5sRm*c;x=jtPrsgQ^Zrn`*L+YG^g*IdQCRd z1e|}))$s!q|8;pTNySW5J~t4?&p$rAy}xbW-pweyFL%dnbs{B}tLJysr75@Xs`KYV z^IzKYCkL2s#GCgtlQpjOye+>%`~MpqRvml7sZY-%>@9w&>dn*nYNG77O(5U(rxJOZ zCNbZ(SY1xQ^JBxMsoJ*r_v)}a9`+3m(_Es<)3H21-Tj?* zd!Er1vj2(JWsn@*>Tqb*?=Cx#2$7XMuP*1q$B($1%OwTc?^Rx-`f>zvKI~A%%%ow! zKW{!4d#VY4ss<<0c`S5_!}GU_3krCw)?!KFuEL%Aulp_RNYS{w>anbwH}xrfW{H2- zJ$FKbdTvl-~I&l%4}y@o=x`SqNBu9DYvgG)qbg+J~; zAuf>>K0u*iyA3+;`0v#U9jmPHAOC+uL}4c00d>aiTcLhH&ptcrhv)K3jgUF7C-Plc zJHPUzY+b1+eHuG%ENWlhtVd+6%en^7wH-H z_xH%HhjY2@m@te;1vskOf2xq@aX%diFR&^fo@(qNpOKtM62Fm$YakQjxfFkp!p~0? zo+*6f#ehu&9?)JLF8ei{dFi~MA}{xbwq-h)hm3&uM)D)u^X6;Q(Pt36xi-J`-rU>{ zm*O3n&4t*CJ19K2Pp=O9HR9k^eS&AwH;2zv)5VUbN;NhGoxdHABORUucur`}b%|?R z@Iz2V~~G&ErjXAR5rR0 z^Kn_FzY*iz)m--9eWD`ixlFV{j11-?K2_U~cge|>$8osm_&d&8b$IHzoF~UiaiuF?Bg{|vPBiCWmUKY##Vj&es61b^= zuJ`&Aek#x;kW+!7XPJKqFLQJwi}_eUjQ1AG`pHa4y8X?1GK|j?YO0O5jdmIbUR3+3 zwxeraIU7U^i(4!OftNBuO)C;;d|D8^m=gVs)^*&ylyr}-G6K5x(PAo~`%a@5Lh-j_ zi}_I8O9f37>~x~`CefIwK+zSWo(eQw&V{LfE*Pbs3fjBR`MQ6!@J1$!(X@BoYC09& z9O?{ex}DFVrVC^-t&JA+_Qg&G^rptfrEuKs*kmajO)q-l6r9#{-zcX7y8Khq1nBm@ zFe7jz=rZ%M-dvgr*EFnpwGatH8?+}uz^Q3>*w?FH%I$XXg3!w@h~DCPMNibYD?2xq z(OLfv2nJ5UXVQNVBaL&}Y^wA9SkHHx;SP9o{S^*B_3HFoJ-#LCmaadxG4ZCv7b)fb zeZAS0h{yWLy8FFxE_$A1k10RZ+iiRAMG#~LDXFyV0~#u$v9CV=07}UPgtYzpDyG=x z?=@alw3lp7=4QN{D!js^tk|3a-9X}$^!k+^hG^3E!8w0T;cT$K!{H=z$8tm6YkXJH zc0k~3TRs9q>iX)h8_mdB5Gx+e;j#834wK!&EI)=p0 z;Q$&hn4QLh2n)^Nh|hz=nXhUy=m3bg(F50o=uBfB0@}u44sKn zyu=@pH5xHT_dDPTJbhgU+ReeESE@EGjt+Dwz>ESljGI$dYzyjkEB&}m?+J7#VLBr$UJF!XQ%Vv;_aZ8 z2j}Rmze-ntqu*T^hJ_v+SgjpBGO*G*dRXA_=$9W+W#PFiIk-3j&*SrLnkY{{%@FCd zUeb9#4Z+jvewCKr)8m3+L-e5FViw$W$@+ge;_~!3!NT?QJizug@9A960Mj!7qhn8} zf1MT^l$^`6m%p;tT+ao1Xwc~tq5WZ33OCSspKaJd(=j(qW-xT3WrpNaOJQt z$6i5EqDmp(3T2lg zoE8!SF*cVsoECoxHZU?VF*G$YHJ87f78(gQFfuVQG&M3cm*Sijs~R>k3NJ=!a&vSb zHZw8`FHB`_XLM*FGcYkVm%+IKDSukukK?uxe&4@BkKI1(ioeO?a6o!#i=xTpkfv#y z;9zKNtyhU{Ig)&Ld&nQ(nUTjUOQe+ajpjGQ`Mx1Jq-05DRF-E_8IuVUuwgT095!5L zJvDq5w8uusgj8s4bFfw#TOt#l?5)hC(9}|y)XLpJ3rw6O50l9ds09I}kbl^6nbO)| z%V)~v0$U+dL8G0^Gc7E}bt2O`r$!@glQ^M)5MUj#PrN4O&19uQMkM^_k4!PiWc9+1}1&&O7Ai zeddM49QcrVq#+fE_EuuFAb&FN9r^~D1tAGlSpbp{Bj_yHzRzUA3-Yj82m)CJmx(;@ zVGm6~ISMc%xipyX9Hu0vnbVL+k!#=wO$kkde08p%X+5M&=Ng(GFlfTO=RuKy%>)<+ zY(g|49E}Ungap~pglIyOn}BG-AV&@Kgs?dVhD?H&AOnadAOu7c8h@J(#{~x=LN0Dz zy}G%7TkOj=`|%IQVq4w?ahnMT^z-c7?A#@>3zos4OHo%Cc4_PiS5}6)uBiFwO%N8`y^ ztB*}_Je~)HLNPX7*ZX79RS(s!>Ygc4)1d29ivvEM4(qO}4`3y&87FI5`rMFnnJhnb zuNj;514%P4E7+>ndoU_6M?tg(C8aRe#qMKdtIhcRY1CPMD1I zP!+ULypAEO;(->L$Y(P1A|>WMlLWSTA*jIOwS zpGR$>aFtkxg_CiE^DG&ahF1?oTdgsQadTGn>98r9sw7L3FXU}1cxlw76q5ZO#aboP zJTLh*iG4;^$FhMHx-SlEJR(epuc@YNp-5GS?rL?pgnxCr$0cRqA{awyBj|p&%;fE& zGUC6Kp{~Muw_1OuC1FII$f>0r8Q*Rn%iV6(m3zn!)ql7~j_vmK=Cp&X!M$<}wQ#x} z9;@wY{Zt&bv{L-^c)M7&&xfw~1S8EIZc}A5L(OCeOq-&80*6!6B7J41#2%|%xuS*9 z0eKrDCV$&q{ZPO?z`BV1>OgDHdKJUErUpzz60+Zvhb`>o{vav45_i2dI-QoWoWGj{#fk_ytJ$ib=NN{ zW#=+8RFfDZo{bOd6|7ra+;Ev6P~d)u?XRi|0)KFudwTQzEj|H+5!7BVnadIO`2`cB zSnHwzj#YsdKcVA`;Du_$EvXJNw1Y#X`hXIz3KfC-eSg{1V?s6Tt~G9nAk7%6o6XzP z9-;Agbme?=epG-bs1d%Yp2|&wdnx29C347k>X{U}sgCuo{DLP_jw2)bb+J8E-D!g- zKz}YLdCWL5>D3t8IDcuPl)A@m?t5%xK;{;UNeQ<7v$U+Ed@8+}@(4(Y1_3 z{_d&22njhtx3~=vFnR>E7sSPoe#`r@*MDQseeB6B=*a?dJiZ z5%%=w`mn*xKAK559h$Bxh^LN1KM*$3-d{N1)cc3(z(R#fmMG>tYvC&q<=Ed zt4R7L)x!m>syFm#B*!Zn>O#@)r66nsIxqGhMibi+-ih1H z$Z@B{i>)1XD(s9tc%lTw7MUX*rihq__{ zE-VIyDYlq~!A*<0G-l?y3&;;&A5b4qS8CJ;#Pw)S?mYITcw+p4<&@^>;eTR@84#Sn zVL!e*4v~Hs`;yvWKM1^(@L@lxjP#?@>FGRTHg=hp0*O*n${Gi!fqq8u$EQI5C?E*0zw@rc+M5+JR4KBKE=Iq{ko zhWkuJ!pR)N#bim`ta(h9!hb^}(vL+WvRHLrH^QtWrJZ+B6j77FL6WdUfh7k)a?UwP z5)dQ_i)2J(kqiP#7_vl35+qAb3QIQ%pA z^>n|kdeg6GYTnEnxs#7H;ZM0L?s_p7$MdAa$|K@*6#fVse+iGr>M|L;kg08=%#%^U zud66}k2`hu@s3$RsWWk~){His{CGlEjr>E=)`O27qn200TD1>&YF7ocYDKha4856u z1$#TKvSFpY;$g%3;Vff%x^J9lO%71G538Jgi6I$%XTn2%T4_my%cfDJ{3uO?hy0#H zPt|}s11grcT`;Zekt{;T>%wh0`KoGzuOmYMRgCZ00O*+ZstjW+p^o!)E?Y2-SxzGOQF9UxRYaEK zbDSGMO-D=gr#F95#mu+qeL5H44J3lUoMcV^(60^nAKfs7Pl-7_ zq|ecjmExhAwP!Zu7UcYtHrR@ZFXCFMg2YezHRm0YA(DQQv3Pga$DQ#lVbXgQd`Gu$ zlV#-n^u8%A%RlJE4T)Tf+{E`HPZ3pnj{Yp8u>Yjha!&c?TRWoD;j#hU??j)BcNfeG z>AFyPd}?Yqo>7I%e0>T$%k>wmp5vn6&`IXU%$PxF>TpH%R8mwg0B$~d-msI)hHaK; zrxJt5Gg@b7=u|s0WUZ%;c8D{%c;28O@zec@7b9GhYDk}7)x(q8>!V`-$*d&$TY^ha zpr0bx%M#rcDh`_D zA8_|1sS_5Z?+za-O}Y>dwfz^nb^Z(=(oUBQ?}aB2YxP( zldR}z8tD@tMu-to{-QW7^_gDX^IW~_FP$zaK#;q8zbDhsYyR02V`;afERkC zyce)3uSCgN$83A~T*eDp&t{$8TDuHxPG3Ad(LbCwtv+1NJv&H{5x;$d{<$|B%5W6Y zb0gJ%dW?56;%z;eIETh^FbzqckfWf)6%`keN^dR(vjHN~mPA5E(6=vGF-)3B$duJw zgjI}H1Vato+`Ru%307fNLn0w9R|mJhUCDoR)mY8tRis2D#3a=;9!f}vYe>ncNUN%; z2#aBU2d%26AtA0NrO5h!s8C>ZFs}Z4N2ipq^xqww+yKWsH0pt+$+wfQW|oT+<_B|E z9n}*#bLM}n+K;Z5EZbWH$zRhxdP#M2OfQ)4SP}y&E8AH~+l~qgWgCqubhN7&V7wlJK`SleiXA@Pg055Pgn%9x?^?AZ9Gx=;&5freT%u3sMgb0i&^ObE5 zLIQS>xn~=O0Kr@`8EjJ!e6Y`%S++VZj?Eo_k#np=K#i_*6D0c{&EkC@3+EIEz9z+Pnf zu6#k*!fFl_nuWkYW(5~m%rOznwilYm5Pnb2sen6AUa5lUDeaO3$5vVp^@xWfG{Rh9 z6l3|>J*#N-Wufr^61P5|DD}*a2*B5_w9hH?m#^@2-jlNkuE+rLlC-TGW!?P}L}E$h zZeKxx9k zvF(#ZCV++W$BeB5qpwOlk^+*YgB&+dSgPG+#hC34wVgRU_m$^MAQhnph})kEu~D3Ki`_zCPGtf3#)i-{<;D`|MT)7G`&iOy9pL zff((Vl-M7!faL@MPMXW)cEEVQ0P$LPa4Cw5vaeBg zHW6b!EbN(;l7judYO!fbD;Ipb2jGxsxXY!c5X!&j6BMgvRmCsL$=1w8qRr}v~jVPY{~*?i(x;5WS;ww=A*usymBY>~5mkRjGw;bsh@lP2X_d5|4C<&Hnv!=D}Y%N<*= zhohO;bcNRANJ3J@=*mM<|gaJU6@PYgT&QX3ckB8eVSnuZNjQYu0Wz3^ZLF z4!=EG1#(Kd%V-vZ=)QD4ZN{Hn#YcvlyE7biQTh=jtQcx{*6{_QFaZ-BljruXe^9() z^3aasxIf3(7H)b>zmx&#w`_m3^F)zp853|o{+vkRcKrFWSd!DrA8PzR9z33kPJP5L zreS#bZuW$S?6sZDy;me9JI5L?-)LK3rb%;v0Y>?0+dRE0zKjw|zITv2RgZRt@}g4S zlu-^5Fz@yi+&96^3VA1MF}a#dn(lpfc`n1L7oerF$t0cfJ}>U&WfI(}QGX{OD}FTI zrn*78D)%y2K$gJB<)XT;7*X1*n3FNs$L_B74o`M#McyJ<$6bELh>s$(4@rt zDIhPiDwm#89K+tYjWI+f%Rk%=bg1|{eF1b z#vxLx;kvhZTFfSu)ZE)DlO6u%NWd+URfQzd7CWx%Aq1C>Ka!({Dy`d-HbR8<9brZ| zPe!C{Rd8wzkxB1c1lFgEEaR*TZR89+5Y>>0XApQBt?0?8=)Nw{IpJBJHk7W(Xhzle z_zr{IsyL*o-cG`SXX@>teZsTMVab81GF5TQd?Xo3^VV#Y-Y$&4dEN2v)F*#6^_iT{ z(7Mu`><3vlHYDB26p(Wbkn7`pO%tXzdk_H$yj*-cT(th>P&Hs=aaO@*k*F330&fOh zt`wf^h}6VY<>7+hm(VD>bq>v~F5a3T?5dmHlMrg_8=~#(ONnvYKMcpX%-zlv?UzI6 z5_@fz0yW8%O2L?!|J(HjZ@62>uXv%?G{NX#4^aAYO22g371u~(M!MgAb-*;RC8tJt;`5?YD z^t2Pa04?2Th%PcJ@m7;}7_xj^%&JhKi=YeT9CU?i4pzq zCe^9EGp1T=bkbnwlg@K3t)a=f)L8kSY|q*JO~~_Fo9si9H#u5#pw{1%;+iEc(@twQk`1lWehciFPc{{~ zX$>W(aR}%LIrw(Ob4j=E=>f%|<=x))%!^ap%^mdW>TqTggM(|(~pb{xZ- zPs%#gx_^db#X)|jh6|YGf2iST8KV7j?Zv%igc<^^+3%(wO*(cm%p}-GT}DQ$vRBam zc2N^}E~19_oTtoOJT1&gJxo9T89g&gU-38P!2%IHBJ%i#{OoZES8+(WkV;9Pr9$xu#>BtJK+t8^Vf$xE8u!P3JiATtk~IF0t@w3!e4o-)m)5oK z;GKB<>~ICBAKDF0;6JrJ79{z8nu`8vPA)e9Jlg%H8H;B1o<$@kIggf1SYN`Mzf(68 zNv(kUo(bG)DnxRTzo>3H7LLFDwzb|m#_D8kuz#8WbWm`7kvjY?T1aEqCWUi%aP!6W zaDPA((<9;RZ|HU3Laia652+fH+glwHc114!U5z>o<@215a@x9-$}?vW`kSoMllU?z ziuwbJc>|LeSwpJmA4L;F*Fo8uJ3ds=k`F&b`t)9kU&2j2h@cAwEHRv4@7C+;v7MJhh;KGoNUh%%QF{R)t>kC4s2ZjT^*IU_xp}EXMr$Fl~-#J~mT!sGV&b z1+|;8QyewOc)Hpy(L}C_+w${c%9I@Gk7T?{W%dDZV(O8~&&ua9$JDEQ+NN1keZc(G ziDg~K_k8^WNt8@ctVJ;TA`10L_BNqF^HaWs<><8u5Z%apOfwV8UYUlsR;*43_i zru6x`hp4%+!AR^WQ%j{0bj^6f;Kh;|OkMp(ThFu(x_15TeA-X{L`VH5W^-mn++*D@ z;4MjWQNbJa84UO=ezM`5-9s<~Sgs^voKtj&avK+YW-f_F{gIx_*FRDDGx=P-sdI+m z{(6@9$w()7tK7r%XsRzS%RFwFr1uVONQ5vcr7&Tk@KG39W1kdQ1z*R8hd=D6Fy55@ zJL;NyCf!aDoCO=X{a^v%G|r%v(lx0cJ($$bU`x3lZb{yA6w+QpcBTrD60AsP2dB6b z>8Uo`zsfw1hMhNrjR$k1zV$L*Q5T znb#BL9q&Ur`FDPU{{!=QfUsK#;7@02 zn~6O|{G*vFiC|dRCKCIK_(yRx`sR=HM=AU)TfUm<;HUUiqT_HNtU0}zsFE1+!kxAe zQ>6psrmNZ5Tf`Z*{7)kp%Wfix#vC_?1fKs7WRt##oI<&wU8Wvzb9mI`o{IUA%nRW zH9zN);R~^TKLYl}q6*|Xi3_Gj?_i=p>ZZKw6#3GF`Phu#j*se%6x8!<{RDdcvz;t* z(!P^L;ul2}(K%bxSCpOpL9Q9mYyI$CGeV;pR$avo1{!_rJTubg`Qr*=*hzxAnw2&Z zRS`Sl7q`G#tHtT6tmd9Aj&rzf4P9dwGXigKazpBK0&wIS;ZoB}Hqqt_@nYH6OJTX1 zmv$4{aK}9>9VAnXA|vfmiOPyYYkGt{7slyd#mx?{>4Hj=X-;jB1&Rv3{;x`v&;7pc z?e8S%pKKPPuiTkjy8@dtIe`myk0sq^JYUu&l`kk~4;0ybs|xu?DS4Nu^Ka~a#3v3M z;RyhWr~3X8y)>a;I#%L6>6|#SD+2yM42L6z1M@1w&xV#_d{lDXY*L zOyfmdIye?6-$CK_@I0U4NEVXM;3oY83*_BDxv`8^%N|x;^qZv+l4@JrXL{YoYWaTK zQ!SnSE91n^C_zncnF5^~!9T4Fwgmg(H-Pe?;A(5-)CNs@|C8D$zD+CzZt0hnyT0Yi zi|L%`cDgM%E_+Zq-Pf<}Lj;Se&{K2=yI!>1KMW1su>^0|Dx-Myzv}E9zK~8T0mt{@ z(H0G{5iK9 zbi7v6KaClxs4D7d=6s8sUeMmm1o?xqZejjl3dr49)-ZStZd#8hgtSl?|MlJC<_AA!wJN(L`>#2%H4PH zKvewt|6YJoJ#IeT6z6+g$71RbYbUQ8*vnNQLtYLco^YD<#{xII?P#5^?woupASJTxa$(kVR@oAQgxw`AZ!yp2x49}@xBxnbz zktH9Fxq(^&0N&}hi6x3b^6&TU1`b*WXXre$@I5P|k;i%F_M1MA8;$%wd7rfG1|5z# z>ILE`J75hEV|~PC6~nT}4<5!!q{9;ZSEzMXmEU2&%2(#5KTs6Nc_0SO)4F;*|8i0> zxVkjWgjp&E$0^U>h%u;Fm=KbF=s zrN@z>otkLXd#`CAzH~4P>Zjl?R zkh54>TAl}7dtT$K_tbR8U&ypW9U0@Bg-q=9RxCa_XS{ zg5Wwr2wuIYZG=8iVO-Rknq}^r$PvFuQi?BZg=%qDU z>OFJG<+m-5-`q2(oVddN@*sQ8_dssZ<$jv<+sxhS_wb22WAv!f`@*gA+dx=h6^d;J z;EXM7F-G?v#TTYS;h$Kd3r(SL)ImbdOW0@rGcWkJE<{hA!sqSlgT$Nnuu8GUJ1h~1 zaTy#K2MUw!5n6BPN4v~2BD~1`OEC}XnsL+bOEy?VAUxhMxhgw1w&B5mF%&5>0f>5SNE8q{Y-qXrbIT=$P|V$x2Di z{0N@#9gr=BeGP3|@Z!SAiyB4^TVm%1m-(^z`j4$p0*@(^9}Y~;%&znBc?-NsTav1X z*EXHLUjJCkf)@?GjJVV=IeWXzLy`3yZBV7xQyRycRy8?IEiBHLuFO~qZ?ewrOJ&)h zJW`Hzd!z`L9|Zi9Ffs*&j|F;m>;(nxjiYf|@ygiJ;cZ|Rkffxj6cGo9`V$SJ{{S$D Ba>)Py delta 203464 zcmZU)V{m3s)BYRVwry)-+qRR5HJSKMa>urv2`9E~+qP|(60W~qvUGU|82Kq7E_i=2O^F}(@FNbYIjWqom>)s$NmGr~*XxL5gEw|&md5&*5 za{||Dnjp$7Aqdr!jjRSQZx@J-*4w&c&~w%4ZO%`@k;3G=?0?)VGdNQUIs`D}$A-}l z-YF87((gx-M5FbT(nrcVMj5$Cn2-KSSpM4-5KRdyxDaB5w(QwXcMdLu!rwdWS+6hD z>q1H~)ZchTT--*ZYrpg|Ud$XO5UKzvoM4LWp?)-8?7~S^M9P}j@_@TlRy+0XUjodD zWuQ={Xj(kAr_u4omn?9J5(IGNw4KkVohpe@ULLrd!N-kzskK72s-&Keb|_5k+fPI~bQ6oDwe)y+%C!%w4*9yi@t{ zc_;9B_4Sq_`$j|_TmL$dR6?S%BvnFBV=1O&5 zL!t#V>aIHwaHIL=R__#k8goSs+LGYJUGlKjh#-u^n=j9Z*)F75vSXVRAFcqpOT1`S zT^JC}enTUbUQtaG)J6O_~q!C_2v0li+Oi>(F3blw@}0PkehDgqJ50z~6(V>JG-xK5Sf z9Qdk_YB%Ija|o1S6gASpGaFl^aFt#ZMblZm=3va;kkXruvtvh*#p<;A(}pl~Xsbk| zLHNNWid#*rpp6nE0X(3rI!yMHA~jcOCRlrlgUZC^S7F#Z*hgcB^HwZR(QD}#3KIaP z%tEN_OHx==Cc9{s`)IUNu!RZ9heP^_6;=?nLGjwJ>4}(kB9gnV93FU39-iP~41^+s z=mR?}_KvK)p{<_O+4aeTlE+c$5Tq%DDVyo({lICkTp%1p!k7w0JfsGsl<-ts^zfS} zd0#J?hZr3NwPOXGj&k$}yy(*lfjt0$J(f6TYAiFaV0g}Jgci8z$or@$W%lhcgQAVfu-ZED=XuR2;~cKb57KIcOeKo!yowbKoF;g>;O{ z7LPT=D1P-w8c8+SR~;MDnQTaBrY8*pZhGCYwJ7%kI3gQr;9VMNdXzI!ggn3lHgE+= z9Lx1Cjw4B70rE_Ng8n3bM;!F*f>h;1UADfEd@-x^D0Ol@+QzU{s{Ne(b$RlA(6SQv zltJ{jM9C`FZ{0_`f_b57{c+vB_UgA#nZfq2^(*~Ku5kyyPP^u_kNGwO#-sLO%$6s^ zjq}CTCOsy-Mq4c{IiJdaeF4D6{kXd?ssALKM2w4-JCy>YXO>wHlEbCD_4NdC6xq=EReda$iOLlb%Y-DLRq zQltB2ri|@twP2G|2+(oX6sggCwHP^wB}USeI0z@2*bD7HilJh_{0%JltYHUqlHX;#vrJl)khTmRZ zpVaYg(q?*7IwJr!N7mb(-W`aHVx$$oQs*xDzB^Y-6QLnm{MLKSUx%xOCYiH3 z)W0|^TFUHte-Hb;_Y)B1RhW?)`K1m;NI03%oLj}W*x|t3rgQI8f0Ym3-us<@T;Vx? z$+f&f+uqxaQ0;dN&k>c&InAY4(SM_N)bQHqxyU~ZelcHGllgp>{R{AiJu6vBQc8C0sG<<( zZDNh3En7eL(cdob7Qi(uCDo72G2DO0Nj=%U-I4H3Z1D8CcvVuI?wCTncByE@@HT$V z-nqh|b$so(C0c&1b@?_5DZViE8!wj#`1H(b1>9svX=Vx4Sk~!SPMS!)wE6W|H~?IP z;&YMXHxn8NPX!Qk?SBkg|L9-y%cq^PWOVRRT_g5O`sK!lP_=p%Qxh1k@iJKcTe`1glS^2W66O^8>WQe}qEg-VI+{eJ5HZsZ?vC ziLS3ZvTWWbBFQ0uzw8y+Y`GJApF*0weAv1^BnLkvbv4DI?faGlM|mrvm0s&<=^Cvm zuW7HDs+iT5mT51jGuY61l}cJ72fdwB|KxPXI}taMRRL&E zNs$C0@cA%1ZX20sF!C@!!|6JOV5kFsvARPVPDwlh8TB(T6c&PZ&?hZ|Fgs$JL)o|@ zu0vP( z{%Solle?f~2v%r7XFz6;6rYDJxmCP&7zOl2g72*fmD&YWi!CjopIbzeN!W6v5r>JtNLLg+4Ijw~McN7nsqa1C z1-Lnt97M&!eIb!45qbkI=ug5g?(%PA5J5aA`3PbV2C@Lv{lJ)aS<(GaY`eidk`8}D za~+Zpp!DvIU#_S(f*nhOp`-`XBY((`5<08HAq8v)7#-~#j)gaAIf-aQedXkOmwhV4 z<{-3-FqB(Q=?jL1HK%e4j(`z{yEU3yNL@IHK&Z29dRT>;-FS2InNi?Rc|)5q5i6}x zs}J$MzIXsNMCn1Tr%735C=T7n8wNcPXVv`HFpoohvtF@kD!Wa_9lKYCN3;fLA3HI$ zme-mwgV8>YlU*N-D4%iY2eu_OoE$WyG?70nwj+jH%WSGKrZW#d<|Ahb)-9oeu{xRz zWq+WL&#LV73x8ZGUmz$gG@A$3+$Eu03jXmaIS4>CL*z0-a6lJ?iHs~t#9Idc@4#v% zUBGOz2l!p)kbk)#oe}=qzHva9c38y#%$ zEv&^r7O$Lyap@$AN9}mB&)x|XOe=4uFP*iSvNT}MWZ%_F$FTIb%lxT>2rLn9?f7r( zWWa&)L`L^={0+(h%*k%wY(U^_m+-F=V~oAuSWyReGs-75MK>mLyZtGm5uLAwaI{Sr zs&=%0R#c^T|HlG{A!Ff*u=$xhZi@lEhk@ge%b5CFZ>@pna8>jzRXc6}L=L@2)y`|+ zF?eVNV}i(LLLMtRv>-iDogM?Qj(yZAAi(ktie*T z8GQ8DuGz5So#W8Y|1HGe1?!!xHIH-WNkqg_Y-KCzY<=Q(C_({sAVLzWgP9_b(0N~Q>RlkY+UhJ8Hi z)D$X_Or;ILr6mzoXA%iFLtBnC?`BF?NDPx5gK=nS5qx18Aegbyk{MA{;lr>9G_`@_uME}5%XA!Y6_W#+Q$GApX9w{=L?vc}#BtzR|p%=GKHf4csKrk}!+b{b* zS1dR7$|0Yfe%hbi)&IVXSM(E`$K@z3v0ce3wXpu)B!~b8435T4QVqI~r6-67To~N{ zv2x&bPZAWa=2#2@;O|{8oh&UrbgzoRD0={VVB1=HpR63lS6;@^u0^usFThZigbMlK}IkL~C z2JeHY{aP6?rxEHRgC>)2P@IYRrS;*TRBKcZ*j-sG1ZfTc1Ab2$LXk%LNROxv)rsP} zGV_}Ozd+h*uJZAO|IYmdFke*=$x*Tu!~JB6EaNTr_7iT^vlZ++jL z8CJ-*pYD;Lgrr<;!*d#yw)ul5H4RF`cq-u#l9EUT<#D+->np;i*LHBB1#=OlzieCk z=#7$k8gL*BN5}ZfGAx{T9IWyj`W>!#nD!7cq<3!u^0PVm8+EaCg1$X!6)S$8*(&iL z*M+1J`s0A#MLbH!&g>g^nq}GwRM}w2DJ&*zO4ANHCL9ty%T>I80!J%GY|Ti10ZG$G zG}=9a4>li&Vk8h^Z6Bofy&NOP`~*0nZ`F7NJ=(BAs~r9=qe;i#jgnbte!K?}50)_O zv~(8%D5Hxm4;n{?RILmxOSl;_OBRJ3(M3-ztO9s0^s=SR^sBFQ1Z`mybB9>kWN0ww zH<#U&f^Ysd6hhzZktf=jCthg8pC07}Y`E1lO}}-m?&vlua)HfDw`0aw5vqLjU94`u zA-gZJ*dokTMPL=)bb5Rue68$#%N=wuiM~4n_7fHGOYq`FuEUh^<2Tu#A9*x3H(nnL z9i#^4gDwl>dkKcO{rZ!fmQ^)?EcSA^)T>2Y8#HbHB#!VWbcwGob^ru)Ay3-B^X58bUH&J{3|8zN7CaydHsy^I8Qc18ewQJ?{SPw&(8P}@Al zA}J6*Go)yl1M6B{Y*kclgzLge7*2lGw7-4HJ-7bIspXH@w+kXwMFkAXdugW%7wGSx z2+`*;&ESfJgQ1KW1)!iMNtUINCJF&Z62}wJak~R3_n-SG7uU}@;M2ldq!V{6u@8jP zl0-7brKxIEA#+8WR_l0T`n$IswF%CM0N2reD<3}hmk{tEl%SD?WK1|Hg42YA$KZbHo+<{MVikjDo zoYA2%U7b~mMNhWSLOsLUL|2~;0-Vil#J!#z4DE+bne<%7Kh>g@GkE zhp08<@g*pmWc);2Y(5Re>S5Ywp-;0&ZTSlGd>keX^O@oy$bheyGmS#%O}(}|r<00e z#vdT;7dySZqLB4l8xA`wqqX5Fa*K1DdH|Kia=(w%s-aMNAo5n`*`KpF=fp9T*UUdA z%k!wl#X<-?Wbv%=)NlpWb3%j8b7UUzADT2fQ&2ngV>BMgdfY^wm0_gW4N&McMqK(-oumM6y&7vL za}@61B>;CSl#)c6;Cyh2qT6LS>3T_lWVpxhDW*F)`7lWeFnOPqHYC!P z{OlDXyDBN+xERKfC}bb|crFMBS=87rUx?DMFp2Z|fQkT6B8-b}VSMj!@g1+e0c;uZ zN<||v)4K$TKekx4J_wAW6O4Pm&7nkgr)7^mU4wjQ7v^a~UbAYZ&x0`K)V{l^?Gm(y zd;w@~%^@*iIOPkk3*SjKj6k19LO&c|rzWt>0D#^533KJOt^R!GqK-11IlbkFehQmv6i? zEir|7aXTc*Av+A68cbD5nJxqzZfGrG3;-^b1~qmB+=yiR-GcDdSu>4puQ4ZN;C-a} zH1ND!?Xo%>6Mwus{pUDD*2y1CBe5l*Mp9r9Aef6G<6vXCo;z*lhzT`Bi-E!b+07`{ z<8J^8{}W*WyysU~?zqm5ZH8H8CM~V(9X}dM+7abM9u54SGul-R(@yO)%4WoL0^q`i zBnlFO=GBw}<69-oLxaNnye#Zso-~z#7Y}2$0lZdE7xy&yAD*J!Xt~BV+oe{M_ooU#VN{eThNQmkcChRDf`67;*9p5sSGuS>cg&xUV z+!=g$jqsR|VvGQJ`K&#}SAWQf0chf6X?TRQS=)z`&lcLr5UY7T`!d#A3nmaxU8`E- z4RgHX`xWO`0~}Hf=6N(Jlj@zdiZkwNG^GLzyY$?k!9teO#1o1P?PSPOsRivV5O4@% ztJq{}WdlXEaO)J(+W9cMv^_p5p0xY+CLGCtx zef1ip%c}S+XkaT_61Pn$DqX)#UDFSTkjd7;dkXrKs)pD;*2sH0<_9*7gAGj8yX(z6vBeeVomt0>Qtp~q>`!_$!H zEwfD^Z&Z^g&!#E0?;(lEmaQ1fP8sM=7sQO_G*WUWd_Fe!{8yGRbrxJpC`tj{kYbn9 z0cEr$lmhU$>-F&T5Q5iExi1D>QZ#Y?Zg>31tTY0-eQK*(%#Z=o0U&)oV>80DRi}$0 zbcF|QLX)}ZYxS=rwYWwLXJik}CrWxY&Q~r@s+-2PcS3Q<9tNm_i0$(b#;yq5_{KVa zgO0rVs>flwTomQsJ6&?<13h4;ezC00ZM-&#dSGjhP`^>|WF9bfbdZW>tu4u6VNG|I z7+y+^7|J6>H>vtc07B^%d|PXeTdTY*p#3_Zc6mn!8F2a+Y=szzlbsa?^yTH0_=!)5 zIMa;hc}K^Db&WyO#v?%R{>X|oUt?+>=;fFQvk=ie;+pKdML9K{>C2&LHaLHlHF|(# z^po&{GTB3WAXwd995{{N;zL(TQug?|9kiHYck&c_Rae>FXD3wr7ecC)^9ehckGH|Un9T3Ql( z5vZKK*Dl%EU8PvgkiV(1HO@h13q?*HT4DQY3I#hijMlGb=f=!qwxyU%+d|C1QuF;(^TA48T>=+w6{0CP6Fem=4zt}u;WL< zyE{)7x6nxe=O5*UU^_^Aww3@XE z#u+A~dlwIJwtWSZ!GMjZYyua@3+Xt93u_c-cZRU15Jgy3kSYx1Jx)j2G7(*{(m9Yh zo?>VPL^BpOR-qfu@|U(22+pc~yoJ^ny&2tC1=zLlnmx+I^NH83By<#86zlW;7|qy{>(D zX*;63&1m|xpGUosE}Do}`W1~kjApM(z-Lu%$bFl$v@O@tKE{(3^2!VA(qL7{mNOLL zUd_dnm0RT>n(h};axswJh#rg#vALNC4Yx^RYM?3VqU=_~wdXGblfw>tA>4w4i9ts* zgxD3LJ~{a~umCZ_wK;aK_4-i7Nv959ZkT1(D%WcQ;FHA>dnZjjQvC{T%9*q6G5RkuP zL?&YWWvd%#G%idsHwgSf_t?W>S@ge=s40$_E_PcJ`~joG{UC@^$S>kUm@B(-H~L{{ zx+W!eI@($c>qoPNlQ(zW*Ghdi2N!nj>j=z(A07BY-;WO$+nKxVm#>+L_gb)0T%AN; zY#$sx-*mCWT>bZn`vxA653^3f6)B}2ZCnk?Y=kt$S{eV;Y5lKd`>s+pJg6(NEg;-BW{y+h`+$LGdr*v!c*JxSJIjV5)2^K;Y zQWZJD4i#R;7>V{l@wswq=W@p6m4u0&gw)|VRX~si91E|?h_?Y5jw@8k;j?rtcQ!$e zZH4*anyCU8cqCJGr!EKHiay*zs-Hi$^?k>F5@%J7+8TK$6=yh-1Mo?-a2(-ua#2BnDBzC!bbq^Bt`g{o8+oCqdl$d3ta z$xJ;42(b5*A^AHkgXZN+vx3-SfX=9P1`|3D&Fl&hNuo$EaZzD02 zdQzsd!tR1r=&j624 z?%fKKOj%+W^Q@g;%XmGrpG3poR9X1YZ=pBk9{ub&p}WN2A6lin3#w+|@mane?@y11 zEkb~e&ll6*4L>{|tUX>obR=DUFz#+X6XS^Yr!76&1lFUK01>U4^L~>hSNYOiA3Ylj zU)YMC?p*?Y&VkEt{q@8-A-jj8!vF&hUp3X~7(d=sgl)6i#QIGM8f8WK5`Ly8;;C3A zrlCKxFN@oXTUkWD&7U}uuyf6o*`l8AZZWMrNzeO|yGA=@@)fA?_crfK#ZB^;hu6Ps z))$_9*XI_F%96{nmu%;~>~*UZ&KrMra#b!DKfW~><}RJjd->{CE1f_7>;!ZfT|f4X zL8iEL1X{M~KxO;0Drc4%j!VJDXtVw8MKNC)hVyZH&miQIr4MpNs@ij>i$Z4~M#45| zoJg3&o6RE6lApi73jw znAN2_X^x=xCrAykDw9xqk`C47Snb_n-jGZL9ScexCN~zRm~p4WTEAWhi(qW@NUEQV zp%ECoF@;V}<9S=aHRCpDka)Eb28%57=hjx3_(eR7to`XLTdMVe1uQnDduY}OQuZrc za9P5j+4`#HZ&*;}9q#ue_>Yeic^LE_PsmRqT(z9n2-YqM&UtW z*5H4`5*S{MbturRUE*|B;}w4I)@&qhB8__z?wgqK{yIhuZlpc1T^Cl1*ER^m!(!Fu zoJo&rEb$9vBgnl{+?$`jd_7J7UZ(RWyL2 zx4rMTVX=D8NmypKdw>QCPm@y(nr8UZr*IcGnnXwd7mzF1f%EnCLH+f9w7hxsIhY%= zdpXe!w2u8lC0NQJPw??j#_PvZZg%?L>&)E*+RSd{E-}Qa)O`!*%^TW$Li( zmDy@x>Od>UR^2KA{A^+H(cbUG7tnsurpzpY$r)=L5bW@mWj1y&{kH6p!&K8_b#KX+ zhUf8mYHeEqE=o{KDN;*KQT^AV*T^#l#GxepNx z7B02!6BVO*8yk!g@n3=OAIf4=f@MJc3o$uCLT?_V2jd3+=lmCBQJBFlVN-joz%ZIo zdBNZz|9!880;dA!;pRzQ4?^bzEb7`juJfRMT^Wh&blC|d?cLaqh&6>ad9Tvf{H9rB zs%e){p^3?`JlE#cyMnI~`pSt<=TOWNcU}O)9w4DaEZcQ5%)yPQW25sb>Cj@WDZrTF zJESRi9E1J|gwwgQ8borNrLnB8Pzy(MkV-Dd9yr0o-M`7gh#%~+#^eP8;#ukLR6_PJ zdyOj^h=69I)aZOVDsFSmCoFtXie&N=k}B?LP`?>bagOpT9$lyl$obiU#Pr!giU`^P zbz9~eH7CY0tN~o+EWNnb&z@+BDqQG>$9C{6HRD`<}YqI%+daeAO*J(q1AS6ZXgj zQpurdso|3yBrKlZ9|C%Ph*6dmsQCNnOCv*hz+QQr#M%s)E-;Z6Rw>LHE;nt+>!L&! zmeIlruyqa-ex&fjWz`H&eRxd(S(>}Ldju3AQfyhCakGfQyo$& z)eKGt()h)3khr$rilH07-`z-{pfEzz=KjuXeC`Q_UX*NF5-G`)GW}2$6`OP4R5=A+ z50dUlO=Cei?Fhk2Dg|FZQbc-9Is$1iLM=PhB-Hw#^0Pdd`v%Dgn_0OXY~2ki;VPNt z>L`*Y5b27IgB}_{eqTWTKKXKpU~g*8hMOSaRazT=tBvkuh!x^Xj!qKO*(vjw=!MAJ zcV<|6*1Y`2+}>vU^i;0JoP(b6v$E9dO?#I7 zL!tcBeXFcfK;sg)?H_$|ycxRdDcJ1~C2YHdZK}O;d z4Vu)S7+C=u#77kklwvFokwe1a&f(S4E4SnEhuI}JSa*9l0<6iOoKgX`L`YtbXJ5xPFn67+Md z6*~GBmf0KjSsn_fWb_4_0o^v-k#A-N9y0aJ^Oyj7|M6Kg2B=xDxjmqJa~dM~DoZY6 zR5l)2URGw76EIo{Xhvd z01qICxYHnKY5u5JTla#YA(cY@{G_%vrcq=-PO`njATqb9KK9Y{^~QRMXraEl_MuL5cP=dT89trB;?7oF~FMax3m@Zfk4kZR+)CK)o42|_g3q?(L|&DGq&tnr~9 zhcs5Z86A-`ydfug0}ztE3&-Lg>}gRjG3w?hjABsE47NDtAcaBE16mcN!P%9h)s+BJ z%)ioU;_!n=>Di;o5p;#T6|X0daOkdsrIKxf_P*nXA;ee3frk-^Y~D6DE9tW zv(SRTUI=*Qq~S2~=LTc5hTbd4`lrt&(Ld7C;H3WEZCF(XLA4z}$Dhq;v`rxVSZv@? z!WpFW{@kGfTyL6tr4aC9F^6(w$`Jr6(omqW1n~rY+n}4sI|D}Jqn9SVefhFFK!Ts5 zUe;y{t1`3wV^1553?y_}3-=lV^DyAlk8Z2rG(o|OuoJCUQu12xwU;)t9kw&+T*%8} z<-dpPk9OPLomGF23wnGYsvPtdA1gYi9d}7ym&tfejgU2idDD*t4i?9^03hDN22Rys zZlyyvqeABlo`yRc-y4lq!Q8h;xYu#n2~lN$VayIXVm%7|XsNgm`>!wBXZdafW^a3;^2o6kxov5GTA zVj!^_msw)M9gzw&n~NbJV*Hg#QM06ETa+s&PN=tj6{BI0Nkoy4^fSqn&GXsdGaB+E z35XNfA&m5g0JVn4LnQC+;@Vmh?b2F!&@8JhBdd1y6+M!=RsYY|$HmhbxDWm&GC~#g zR#eQZ;_PkU$rMgI;)4F4A4-TIHcd&q&2wZMGJGEZ%?%Upq84&MNq##iDz8rGvW|ZM ze5#p!{140L5hEW!0>UuS%N6BR;r`Xu|x>gITjSXXa`}7EP>e^778K!Sj-lLV3rkrz5I!jXeWnYy=Yk94yAC3IrKG){NJhdNB7ymi42lzMoZzHQsad7&AE4AHksG+rC5J zoH}Y0MIue%N@*eN4;%?~yG!4B0N&p33~wgOjwwGA=3 zR0jyR`NcY0r6;ZXoLW|Nuocvfab7voeGn4v+J;smlL>iPop2xGB`fJW8BBGVc#PMN z%?JiR@@bMBEf`1NisT0k8Fq;v>eKIm< zi%)59?S$6U8E?v~X*%=&J|aF^v&`62U&myq?@Je#vf_qDvBN~h(@9i$vZK>LY_C5Q zzD{mDRu}J2!#J1v;9q87uy!cVyG+4}uS_mcG{10iQ(^8^JC{?GlyLlc5q1xnw}-6; zDf1rx&}4jpFhPMgHBkdY|A(Fb1=R^@uu?cs_WuFkFf}kacuA9FSRaOfqB7#a{n)?^0KGuhGB80Ryl(q1H@cH#Cl-jQjc`=ezTYsTB9ET zr?z-(2rK`l+JYSnKc_#+)+S~(C}=t(|CX{5825GOxu0N9f|J75-#wtAj#?eG$z46f zV2#)}HFFNOQ!lBZ)i5Z9Kip*W6^ai_rKhW{}awJ1TLF_@sL z|7Rer6cAav@~15gmW#4w#17p>r9lzSNjzG+hQgmiow8j#sGXw);})q1L*B*(&zTZ> z5Ys(8a+8uNIW61t@sCFxS}Q@IB8FoMtTJYcYekfdJFitAM2vB?HVPNzo@`KbCzF!} zV$EQN&ZUG&xre*TM^Q1`EKM3n!q6U1oB{@V6F_G04<3v>jY;4)kES<;PfopYAbmxM zq&+r^%xJA_4vjujFA>r)Y^_3hVh}bfv|L{mR=YB!Q$b?X--u^a;UNeuo;3;+GOk`P zZ4`KTD$6KBtV_EZaesUcJp>XGj{Zv8p3$ed)ep<}0gn{6)v6sOC}C962!nvsxq&_? zW`M00Lgj0d9(+LlO)=d1_XY43gc~z5(jkyrMLaQs7=?2!9a7#V4t66z#?q=;gOlaV zM)<}QQoq8zi04A8CbVVD92re(@Cnpe8PmBStVfrT4kZ9%qz~-3au^i0w*n|>Ag(Eo zw*Hzz8mSIOyo5;2>f#qoOC^n|Aja9uI$)wBuSvh`i9o&vKQS?J^x>mlVZS&QJJMYs zJ;&b9;CJpfpV5aco9`UczuT05{SgqWO8_}v7Hku_p)DI?K<d^`Gjm!`l`cKci>Eh;nbyv?EyrV1?=zp;JUd$29KKG71TuEEZvi_8 zXOJS2c)mR`wQ)+Egdz9$7dEU$j!dy2v{<<)rg;>OtCMA3cK3qPARKx*-S$iMx3dsW zVTAkoM)5=Pdz=eEYsKv;so{iL8OZ@XhE~hzKkqdhnde75+9=(tb7k9d33t|f;9)t}Jfukg}hefhSkN-(| zRk?95QLjHe%$%$a20?wjVG0OOPDJp(bMavq0vsmda6LO6e4e>B<}fm4baP_w_p^S9 z5!VC3zanW71Mckv1qsc}U@BE}=XTOEo-H2+?OGi)?^io-e2)y13$(w2GrvBGnJclG z^gB2$BPSmp&nq``x2ger;3AyV)bsb)B|*EUN7io-wS`hIR&2goOn{}$!rVyCm0kDA z>Tf8z(UT zy4QDDYZ~lt8oaf(W=-cbTpJwo*Q&+X5bi?lS+27bH329_R-ci*|S?;!cUY&uzK)@BtKO=`-RQ&&sB#& zu8dI_)^h}98W~MM;PV4~wm5vxGvqd84j$UQnutG#y(xQ!0>WHx8plw?Gcz;INZ6KA z%o!G*{a1QSt$xLk7C85W%!V1$1!)B&ShYyxi&U6}CZwDIq@=H5&7GRF&j}B%rZ3}` zk}pfaPA7lH*;h&Pf)JV8PX4Oww^Mr}J^pNhe5CM4H{-WXbrCVkMOu@X?2!(=_JCrrNooxJqNC~1jeTU+BTJ469UJ&J)->Q zF#ifE>IvZqyaI=~hp*2(nTp>}rCff(+H&f1s6_fOiwoV~!rGVkDAVdt`8L>-t3I1q z&F8C+u3|5qtI`(Qt1Y(6YE41@B;`OmTn>DccW--<+$b08KQ1Fo_1aei4fU=HbfL>~ zu-9l0c>seT%b5oO##w{%E~)G1uy3N}ZIg%Tu-uEkeVYO^1-{*Pl>^MX@OxIDntRg% zx5qgzu1X)RTQM8Y+W%|VP*?Eau0msJkfw4%Sp$has>WH11#i&v$m^&Wwyq>kx3yU8J)S+lGWx~- z5ATtyJa#Cq;`Hjj?NE5%aR40nB#V3^>dJ{DMaJC_AXE*~!6Ej$i*=hDGbbt*03+lO zCn=KEUKF7Y;kx^s@>~owk)a@t1o1sSd9uyMby*7AV^UJ6RmY?XL3d-lzqxZ@&^BDRN(?Zpo{Bxi3-K0QtTku76}eYs#QZ6hr~(D=^qbE+dUm{YuK40B?v< zIhsP=DoJ7D>lDLbBDYyh>d2cg807c`DC>Yt*1XCN5?vhaSKq?;+nmep032&#yZPr` zJ`D!igQxs^jp3Z;H#0;2z=kAn5|wE9Z8VyvQyTW!_MODIEu>J_rz|vAqv}14^Z>iJ zWm_*095%YHlmfj9#h-~J$Va|DzihK%&<>+omkVR1noEc1B}j=r)Gtr&qx9SGyqmu< zo#nqY2FAPW~p*O2Xf-S?Pl8XMTGYX}ENh5;( zZ_zTd5R4c0|4i$hRDeAp{#)^%iXt)(@BeFTkBu!=Wad9N4|P=>@mo>-maBKn-jyTz zcjE|pXySMtAN|jJ!#-!0Mu1bR1VMaj>M0Q$q(WWW6`D=vdP_s``}blai&F{xyA#~o zab=WkJLPqer0u$e`*hZ;G7Vg<2;nx}5|WwOn%+z?rSJKC5v>JNBG!FkLW!i&7{T$bJDMWiVK8BnHi6gY? zF)H>1BNVkVi-QCZ)q#-`6+kUnSi%ZMY4K1(bj=D<-l1)2v0qscqorm6Eb)0jQ23O7 z+*~>xYMs!T0MsxNebW#GKU&J2CqRBk8Q8JzsUZEW3xAlO3<2yk$hcV(nbJHHV?4%k z5#rnUT_TWP^oci%7JCKvU6-y&W$*}?C+os#Y>9bqP#;qI*RI<*EQ2NgQc6KvD}Y!t zfRwYplcFEACLu#?a0DjO&SBn@S2K?{<97ytWj&>T=S7$iu0apvN#9;3AzzX-b2<=s z+4$4SMORWvs_=GOklBw%PabP>cJ}4tk~Y6JiwBRm+vP#)BYKGX(rz~@#S&JD zZbCXe&kJQd&ySuz)wi<*E94g35*DXV+%me;R~#5lS~7;Toq&wFvHI&amN^zVx^Aa* zRruc5&HZVuZ1t_Ra-n0YefJ$u*4TzfwSm#mcA9rFu>ROHj)g~!;}^RkDj4H=Q^d< zsva9t8UYQbG?(oYuFrvr4$4B*1*X!D3D6vV z19re|`ywPoQPgfWV6(w2^XJB0I5iri0cx^BfieGExHv$hOzGwCfa7CN zc~Mui@3?O!k_>{^3d0Bu=jNVeI1EoXb4HYgz*sQ;4ur;YvJnAy5lDA$j-v}}1LhcW zbSC6(tSD)%heULqw0ALuoz|S8AGIJ6QLkEQ*WYMw7$v8&I$#4oF+B(n-gJ@Q2Tns# z{-QlWyEgMZ*%PZjjsoE1(8h{TS0%;x6m(!Y3@4Vbo}!PulECnNY*H6hZnE8yqK{J7 zdgjNg>`PG~;_B+dVL(!MAIRw|R<|ZAlbLQyFJxa-D@ILU{+xh$ zC^9O0O-cWQ;4A^9s4Lk~PO^6v>#p9U3|(AWzO-NT#@(HiL;*l~NrMPl`ZYXi*YxrE z{1YJ{7j#tiQN;nA3)Fyi=-Obrv^lZZ{G=DN33SiuhaLG!u^_8j=DZp%6j`Q=H_n|{ zT|3Slunwk!Lq2!{_LWD7$#wuAA+&{`NlKyv0$u?_?A?u%1lZv@V#r%jvhZn&Ixn|M zKiu0g?AL0YBm;P62BHyUKgNoT5&wXPAY@3o&VAX9&ZfHO2Bka~$UC@G&pXIzbVW|v z0H+!kiG6grbBADr2~>sq;P#R2o=eHy>^+~p9if?=zSWA`A|`Upc;21Jq|r$5e3HIr5eWzY82W7lEbE8vKBnk5Bsf&d zL#;-zUMI_u#6oq&jy-}9ve)Qar`ds}2|?KXK5AB&^e&Di0lHJ0vZ}HR{0LtUtg&}m zZ<|_yXhvLUgLlxwCfxRE&UeX$981(8scvY%uhGzZYkIN=B$0lqggi*$&H)P^@@NET zBKYUyB>^dyG&fACkx%`h;CsTgwyCDrp)_$IF&C=@B7;@JU80nNe-zzKt@ITJ2&1tft6|r6l!#nmFj0~bDN|=NTKL9SD7ShJU%9K zdEX&SO{s#fy6)?lg@;xwEF!q|D5grBp+CAKfPTBxNll~s@m^9!wEw`Vwc{hY1nB&m zIasN@gj`{rb(!ykEMEG+%Y=cXRH&z8Q5UG3R3Lzh5KTMWou_r7l_guATF_@sFDA0@ zw9NU7&SE+Z6ij19R7Ah*Hnl!_%R4-!sL39OWp|ZbteWN1Pu zN2tH%D$c{;NCS3a&xHjrG3a9nJPDh|2JT&*3FFCgce@crup8TWugaiMHM*F;sH#iw zI|3m!)It>ahC-?tjD&$Cw??I*qt=i*{0DTv=?shN4GYnEYp#s5wbGu{7 zfc3fiQ-l&*r+;IQmkcAIMBa*>Dy7mxYe)!9p*GrF@qS7n_IU@o^OJgv)s$u;= zJ#dF-Hb^nSwjwwZ_$<)#&}q^G&^8_i5Rq{aUzoJkh>+AcZNY;8>A_apBRI*B0^R)q z0T6$_L@bnOe<6W%uBiF3$zO1&Bhh3}x711;BJya+#(!cd*qb)PrNW(eAjhMl$V#ruP!$ z2gY%Yx8}xiSiVvL1;oq7Y%i=bM&&HgLYB?gV`|4rais_LdqYJq7306WIc|wf^sDHb z=+lU(G%vZbcmfqYA+In37Bf4eGRh!q^*EN%S%3m1g5XUl_pmY6twXS#4er#p=MDVn zyJd~Q%0bf$jEUQzuXO3?T!;D~ZxcI|?IO@CX~QBnH_8M6UUKH;O`fHni+R<{=HT1S zz{R-dpY83QJ*&r}-oqg8V=BSm2$pccD%#fJXN-PzvWc~2tsBD^?K#KH;-%DdRYBi5Y#7#Y7SZ2gp)@!4ayJx!5%1hcz;l}y|Nc)-F9Zjxw9izcUFhb3 z=G+rXuI2Ct@A} z$ADfRp(2~Yiw??JdV;EIZSQ&KzPD#h_)FM8@usgf)1(mS%}oe|csq+Sb-pJ(yJ{$+ zg5=5L*%q#3%Y|lTIFka}*4#-oAZ;Bnk#-mLozD!OYz8 z2UtX^FC^bAZ-9HWq@K#Krg`1<&RXaztxVT{TDi(5I}5&f9@Y}fsrB@+Vk>QxWt*dW z=b!0W{Fs7N%oyAUp(b~bi2N9(9LN6COh8He)kjD|mw4#PZX?~lCbTuvmOn-~H?RAK z+!>PGQetK_oboRrg)cj%5!G5|3qhssxAv48W|wC!Go!dWEZ@!e8eqe&#;Cp54k2$_ z<&3ty%}`2)J@gz*yV6UMoRBD~ESo0ka0Ctz?>Iv<_U?EE)X>G}-PAilLROXI8Y_`B z%znd@Hik_xG+g8xOiod$E%dC*G8B~vQc5*S&DFf@!lONpuckES?7lUN@DI?)0v}S< z`5Tkuh%xyV45TRASle*ssr5&&uSsIEf_PN;`G7A~PqTx20#CO=z#9sX7=Xu!^Xr&N zW@?x9d2pr#1=o+-afGgMU)t7;VTIYMOlS(FO{kqb)*u-4G1cR@{fvyGzxz`*j}(<8 zbo50$`)dh1(mKMdM87e;G5@TDg3$0TssbVjR#HZ`HJR0vDp7`Ys|{qk^g`fLiBy{J z#2ruTc0xNqeG!RH_iDndG&F8ovQ-($f}Z=yNnIQklv1c)5=sV;cypiU_)fk~E4hKS zw&#{!A;jDUSDc{>bZx7y(G>G3|0*$E78H($KyYYMxXwb8MOR2@0kn4s-}S^is7CIE z-GEhM6PDtrf>q-;F)kqsAvB7?)F?V|>i+WG?!@oBLShCV^O7PuqdPASElx0bVz3)cJI!HK`i}J$AbJXS8uI}%yajYCNW>6lv;>CMp3ndG zgIuP`(0QL$(}MTcp#16|``-y;$cVH(+%P8Vo=tg$E%w&E?{>uu8H zXTAqDy|8xsHxxBCKZF(kd|{S(u66KM$7nx~(V%ae?ek(K<-k60AwaZqY$Y6idrV;W z1~J-kPgAR*(a@OLvHGQ|yK~IX9EWu@+9Ld=I^m`1(VZ>WgoTfPAolLZh)R`VWUW_# zu5lf%D4B8bBM@BPX+%0fqR_k5?L?aKOO_z$SjjP{B-+m=|6RgUvxjOf-s!fDa+_$9 zYfmUZUVJQ4@yt9d>j75#BCy#e453gq1A4d)80A_NUDy(@ZPq;LD=k!a;4e{K7*+09 zTJ;avygI-BOO*7deg0uI!bd_A2$44287ETFyzYD1Csq{rAQ;w!m=^CC{}pzgIPVzZ z<#$6Y8XdZ1pxTOMuy1=) zEIxzXhb6=B`sjKyHB))i5Dk&{UbDdHeMymU*ic)c7@0?R5s7ssFKLs~A6J*ZWZN~! zHcKBmOc3DFA#FCD&T0a(D!-BxUs{uVtI}v#EL-`eao%8amTKCC@me@Hw)8pmi&S;c z)b(HB}`8Qc+GfE{J7=i5!>gTU7uKE zG)<_i=AeKNveuJHV?$6D((GH$$S}*3RA`9t<{2TQbbD0_#WkXJa*oencOza9K37?pxV0p1^x8) zjKBN)%nu)ZLncq{FK_0xS?@!jG!){gjqKl+W4oNdr`-YSxWH0JPTmayVFj%|+ZJ9z ztf<8KJtHfUp?zA*gZ<*;>MYQ8-}OkW_vXQLpom+|;+jx!X>9!>!yxK&UZQz2kA+u7 zhb6t+>40XPvM5wVZ2SB;sBt-AvMB>sG2{5PF+*=lvCZDMVAH+zH@=RHJBAdlwkaVn z6uUp=>9q4EbgZ=3ed;e+z0sTQzVk-)e88q0b7c`cHwBKzB>pJp+uaS}+ufX6z~`*} zH~cFt9`!Dl)`uJPQ-UAEf+NGe2NU#7+^@v(0MI{~|J0;0WFUa|f3W5QHUuZ)KSn?F zCLsz4IoMQ1018EF1p|aOfR!f|nh`<(z{;B{!3g1+N=E^Kl&T9rAx_<6gpmED^O%?* z$kA9oy8~4JFUVwNWn&97V}kfx$j^oPT zK0CYUQg44EJAtz|S^PqlfcYme^RHstRf0?m_m5-o2pOa4wgx#2<&z}*Z1KWqitRzh zf(P*YtKU*1bMgM)zk-eZlNY3b_=gw#1iQRwpJ4Zj)eDC!ieUp<3e0F>8Ejdn?;604 z4v8Rn;^}QBAIg--5Er|tR}5e_HDF-nCM zfYC;#y|0GRQ)-H*Z*K zwDv!%6R3WzpY5TY@Q$*pE+~63i@+C2SC1sbTVVw(kuG9jx>wv|opZyI`L`*fDh>MZbd)~DnLkBlAWx~SxfZIGOd4L4 z#zb>JBXdG3?@d81h?C8|J{?@9gf+MpcBAx6J2b{F&L9B}(!DOWF#f0W@E>|hnC5tI z@QINE-Mg$AM+b*0t?akUGR^sSYmS`zGVa^QI_I}mT;DSdnB9@;oOaHovjct$^X>62yGcfZKg z%xjrCD!)p@_M`2`>%k?F71JG72;I1^bu)%>h~zcu_&;!?ncq*8I=?U#_c6aMKRLg+ z9vFXEJIUqb$LtW1jf0E%z~XS(aayT@cyN{Q(@To$N1?N~UD_!pWY?soMQS{BsPVf- zN_G$O{P_BGK{PG>E8Us(%FfHDNxk+zA-O9c+%*s=dCbmzHZYS=73zcVzy8{5pCK(I z6o>0n%A`y{g=&cUi%t?D_D5)mGNGG*gTD!%f)v^MdY>_2E0t5=qcSeo`e)*F0#t$s zIY;wUOgx24&{4YxT65TB3Q9KbrbwTlKYL*dGUPVw%up16>bz#Fr*_i7tDpQP!(QwlQ<&=7y zItm}>E_R%tLeJ+ftA~5XJwnaTUi+|>6fc^0uDwbN+P=W-PL^iI zRbq}&W#sK9goX=JBD7%Deuc6LIR$U`-k~Ab2JzczNAyay5qMyRSTyY=)7ZL3@+0&* zYQl*aL7P0_wMK;zVl}VV>kw0-@|NHfCnOd$PXa3vF zv*cUhM@#y~^}({o-NCoWCHpH(BQ0G|mc2HO)I zLeMvPr#3h&oQS_Tv26!hTI-jsi3a!OsyIJ?7=B;J7T$Q1d+}L)`_n*(;@qVwPb;J; zM~l$I2nl~qXb-gsKPFv+sY<{1;5G~II_Aw?7o~fSiw+RN&BY_`wK9(G1KI2Oo9|nET%XzcnYRh=n)tI2PM9a0jQi-KL zoEk_wDS0o)ohxQW`96c6Fp8ylQE9Za2OCW$DKCvGi(kssgHkOnK}!H9B1bf-FEH2J zfH9?dj)1st(86i9mOt>8#OV%e48({O-$2+$qNhBJlQK@uJ`})14q-z@2d<5_EqHO8AV$rGHQyO%~ky3p-@8^0{r0CKmu{mE7dVr2Q!y+2KOJu|X-8ND<6zQ0dBek5Zi*c%z>jwG({4j0~fj1;=84;N-7Y*3{( z?nnKN8g{?}v*Gql4W6wCRL)eWioI$BM!C?lM6A!$#r;${ zWc?fnBgoY0+>URwEG*F3+GyD)|BG>hMc4wh!I5iAc1DJY)GIZ(ieg`CWSQUY3dIcZ zsp)#8XWMLT^7l@NET8F!55P!q*e=e&@Tv96^G9&5sy9Xz>5e-g;Od=VffzPR%nHGTG?DkA`RIGg(R zk#hi_4!eJ&BW_2?*Pl6(CaZhoG>CsdBVwxE7C3AZ`ZF>g9Ds%AA3*00&KfodKxrBT zpi;8`hw-daMSdYeH|cVrT12OwaH1kLjrXE5{R8j*O-Cb-qe8%ZeuOCgryxufjC3bcFv^hgnZhqyCAiIGuoFGztAhwS4YV+`b!@tbZE1!r zEB$aK;2zh_egJ?5uWV0OWo2m<|ImGi-6gq+1I}*gleQ(F1poZ@4$< zCP?@_HDb|c%u!(83mXx2d4TqIl*!U|=qNZ2|z&o%~5PD)=XX4Tl zp3S~7KTTw^F-nCJytje~4QIDRekOySp6={AdTVun2C`j^KT*#-;eldQ&h|H8)K+FK z)MWeN5Bb}!yxR*-fe2X(v0>&x!}xM$W~Rh@muYJl>fPt0HTUD*;pykE8S$vhS7sxj z7{d-5XV4p;w+B~S){oej)=wS}_)*DZaHbez;1iOo^62i&?jkK+=^YhNd0Y*Q>~x8ZxG1r_?t0vy`Jykgsgj=h`-!*{Eqo}JqLnknFO=6AB; zL5*GG_9d78ESUV&_DF7q`%!+UE}K8GidX!i8TVn_?UL#cJxu&{`{I3;5ZXw|Uf`8R z_>>{Rhq&PvCEc7V)7D)LFUs6aybjKo-B6klIdTw@vz~tgohhQOM_}LdM z3K}IMs?!UhIhzQ0fO(+v@$NPR|BCYAO|HpJqL~|@9jrWCEIAD!hW%^C3es5R+LV+v zfjb5>3r?O8%)l_@!X!y_VH+-~OC1_~b%;bsqexUH>?OVuLan9~*CNiba@i`lWhjJ^ zV*f00!K99C&WorF0K6m26RX&h&E1s|2l*VDG%w+ij?-+FOAhTkg`(CqQDf;m_9x^V zM3gr&wBxJ1O0QmGt$Oz*FL3Mkbt5gdN(oA0^ps^kud%2;Wx=Okzql%zwDnb?|e zSa$oDEA`^9zn^^PdZ;Q+<<7liF3zo@h4e*6xyM9Pb?_dCOqCi8lfbD&f>L{M0=4l8 zE4(+ii-sDZOohXxLqgQcO9ksRW>{jAFYv?xwV*uMcA&S^#d8t{(H7|ACNX&;&1cyhTMTzFn*Y-s- zgSo#?BlI5=Z6OClrY)!dchOa@?fF`|vWoYr+bVxAm5zReoG z9k(XdT}(X1o|a!9w=GtBUs}$-UW@ih0;u8iW6Hr`NKSDC^ZX5>Ju5A|LESvhZqc5i zu1}uenO>oEW1gZIzAN+179O zmGje2WAn-f#so@a8v$zGBFkVl=U3WuGk!1J`X+&39yVlBkYrM29kz)k_*-`^8a&oO%_#F5!b+Q~mndD6mQ5a@ zwu7mt#4m7Q$bz+4=%3&t^h#kaSceXgv-0WA8}ArqXY8i)sK*Vz z5|ecl7q1L#;>rxN#em`(y5@1}dHXdj*elSN!eExvcxWKzf58CsrdDX+GQwvT_FrbH z1Pz!5`(Knm4Ie0mkZQ68j@eX31-$wPcKn+isAK`|{ZrlYZ@GN20MHxi6RP}6SaFL1 zq2T`aZI$JL*9fVov#6L&np(gf1OVqJ#`-6F%U}i!`6r0`?@I<9fFy7b?4K?4|GqbG zAkZ8hf{pusAPqO$|Ho{x{ZCQ-fUdm5r;OWqt98f9Yg<=d{(=b$ZELs3umu)+E{@it z9bKRk0;|ABk=%g&e*LPEXck5GHKtTY8m7#$sOa^y(&PRq>j(Ru85i1>Fs69n5t4(a zLN#1gGAgY&6j{|L=EL}TQUq0TDF;}%G{s`eL749jOruZ{1P@+>LZZ2wx z651oO>YFsTDqQhFL<)E&tOZUHK{J&Ji-_sm*0=6lpKNdk%InrDRS`+3Ja}x9EIR%+$hGZ_s&Piv3?{Tyjs8Dk%8?UuBtc>pqowFI*MGkXaJ zD}>{IIIHWFO9ki#>1To(SDMabi>i5~3!fn3Z)JmeUA%coGg~9qY+sUbKX!9J0AhO8B=Dy5)m9#}$E!1m)XC3P#F|q^RT&!I?p%JiCzRWp zZf4d#?{m}WpVm0++vU-$?DT6WR7hJ>!bgA$LZgK*_$erY$&RVIT_!iTgw4kf25)as z$#pL^>iPcE-Gb>e<{OJ``M2n;nk_fJXBd~#FUn$xk)WuE45$rg@_r56+(}E9X!jO(=g4Bd79>(aARn2# z#0qNZt}KX9>BRF-#$gZNNp$}8XCGy}bm-4FGn2MxHwxn1e_updfeZRM03+2dARD_2(QC!#;& z$o1xoylW7r^c9n;b!YD-~;Ha8<&`3xFqE3Gdpp-DO>ivODB5041@)Y@F5Qr8bj4TPQo}$i> zN119%{%vo--uy=kaw~d_XuvE1GQ28e`B(7X5XSJISx}Y=8GK9q$FD2O)6M?=WTsH= z(KKH{oNc>cg#uf8m4~w*oKZ?2_E_A^2VIR(R<~`-3UyCB1az>a2jSqo0T4wJDIB5F z4iP(xA_^$rW#Fvq2;s0=aDd^fa=jkMR3H!%{FFxRYK9N;BR`q}*;{c4*Z0bXdI)!< z$2Oe^IDZLq;|+WfZ4X1__<7O)It$^ojI;;h%_bUl!A|&R2-winLI+9k5yQKQo@+d8 zC4KDz3sj#fiI8wb)yU*qdPI==By3mbQff(J~<5TagR)sy-m z4R3p@HMA|{`Hs6rsgy(QNvg)M*t40GG|xx=BCeao5RVc6iHJ+>6--IQ(Rps}4H`r1 z+FLBvCF5Ud=vP&2>i?r-ddyJcI^uMUc9alSuQ2Dd(8DFE_D6r8UIUjm`Av7p@WXhgv6xp7O6t~ajh z$!l??VudWj9Q(|fZ`_bMOavxpS=c9J=W};vRKHohO4Loq0@gk3^wtB#H$aHk+U4}I zE_VI=l|Le0TDZFlC0hr6H4)Wn{v6%Fd6B* z_EmnjPBq7a6v!V2raQ(}E9n2krq9*;9*q#hlNSpMMH5}<_^Pyr(LGD*C~3-GdT9J< zo7HfJXlrzbK`hmuYoSck_XlBHN~l>i7-VqtL-VGs+F?!#n4d=nkL3*}pe^ziHFg7T zoWfYPcbd3#%O2b^oaS^d*xfhKl5LRxB=Y9V@btnrpxg2xrF=rrhbjzr7!A;vSmZ;6 ziwDr@T1NQ%mMA}b(-K4PHRA=I%MJl-gD3b#TIQz~r{EW{soJ*8Gmw%8>zAO$`go!E z97C_)lKDi8x<*QBael#Xg4MSfmyDq1?8&N(<6=0~4ixOfuWe>Ct~+p@g>rCob`S4?$SINy-9li<`{asu!_I~rIjV;zVOc6-Tc{v@6Ffu zBA~!y>@bHZt)Bj~8LapfuuaNt3|IId9zV8VOvkFj^t~+hO#I0a&qt_Bk5T3QSA7B@ zHAzkJjV-H9)#9ph%&p{aZSUw}E0U01j|*5N;|bCWI)%6#IrR0)Kel{g-$Oe|eWb5` zD(L1`s9i>DC)_Ow@PrG^-Kx^INH2_H;qmOTrfE-%Q(_9n--4QxdO2tKUC9TjSBdg9U>V+7p+HtVl|9 zuHea3OM>u#X76JQD|nu^xjmizVecpt*=9H<=R6YO=??K@aM37;*#YEJ#Z`PEWv__e z^1S=x>*9TTV^F~@7x~4~#>IQhJbhZWS=OA&9Fj3?LO8H<GowCIdl5a{yg zBFYbx(|AmBSSfFq(pWg^>vS~5+}Nfp1{&I(@={{Ii24mbnm|`L(WDDa+%yWAA~}!E zw2rAE-FH@aOk7e^(k^1S4@2v=uR(m1qvdK76|{7b#{zFZCE4_Lc%Ivh!;cA%Zc)G8 zdK`tOeL=4iS*V_i3@4EH-x@!_rnH2#i>uw62wcpxY7 zMU8e7jH()O)i;Bgl#R`KEa9qTkr@q1jC0$<~|2yjRBY{d^|F9X=bP zJ5})Y6K@_#xQuNH?H*F`7ny!21951u{+MSj*vD{#d}D5wL*$FNlvNRsEF%=C$g-#3 z-`nT69u^bvP^1Dx@|_ILB|vGOxBCieLhZCSG0`_?_w7EZ1+xR)c+rvVbGIw$xIoE# z;dZGG$KTO=-(W%(9X3?9kr!^g(O4G~LdcN&W&(7^#_9NxVv=z=Jt~CfG#rHQs}=}2 zq$O3P{}-Q<7}W?X(6s|KXbKlFiFG#Y}AK?zVCQV}si zcWpeZ%;?m310c{6bJm~TItwT922gTw*mX2LbSIRxN`C(0@8s{l?HQv0s>BgHYtyy9 z!rt>>=@0#)(Ts6xI|R9ho)TV~Sgw{yp(aPPA%?i&(eWe9^ILSVCt8drf`2iX-v`9!!+=v<5bg#tl7#CkCKxv~&&1s=_~WJGb(Qp* zL_y6nRKG@q^7RMsQH$h4V`MfC!DT#I;`7D=pXo4?n+yv$BeJuBmI5KNbDs=5tf-O- zrf+Ty&{-2m3mBqDu1F9PL^6EDLh zG6spHr8b+eymoYtaG#0L1bGrE@*N?J04y}q>wL=lEcK8<%2c4RUd%S*Fq0I>Djg|B z;w4N1-aLzpr$#|AgIui&2qbPT5E33u9O~KxxmHjds7~aFf07NysyH1bG4C5%J#lMi zr{fNU-zAyJNL#SUq9aUlQRtJ1l|Z5{?~NiRta2R0ejKyYSqK-!&778>1P{dI`5yuZ zS%m(c@9Fl-gxC|@iv9GqknbA3PKf4d`^6Q@W7s%xkFkNmIW(ZW99VF`T}R;aXI3yNoi{C1#2*MPVHJMP%cu%;bOwRos*Y z46;A4QBOKRPNN^G7$Ma;cetlL=Oka{D$)K(FI+F1qZf&d?ja!FKrYIP7cghC1k@`! z+kkKp7<hD{rxG#E?Jt&DT3Dvf1~tmxFb;W0*)(Z zH~f;3;3#gx zh%%hOPmXiy$5;{&3kWbP#g%u0OmQ$#NC6qNEaFY_;^taF25zl{ER3kH(Mymu8;Y;; zb@ykRhC1SoY*}f=*J5%zCj6fEeP}*K3gylMzXaBS>V|>c@@95^q_R(ZSY*ux-dlgj zW{!I$P@7-z+&$AX3(b!1Xe4!rFPkc{8iQug&-5+?1&}pJ_Xw#lgZO-*8Wi!`8>aQJeH$Be;*40rh>_aRDN!P%7or^|5o& zh^petdC+}qH~)evQ8=fH=>g0$<2We9>zfL$GdH_Xv2UMJQM&8M62rv{y$6$`)oc3l z^2Yj>8M~nJQy6x8?fMSxPZ3bqb3Su)6?A?ovu|JpM<-r&KWMqJNIZl>00BEaYs_K` zXX{C-b-wiu5^p`;7(6x@7WQf><$0;+55!x*N`TOH1ejf+oY&I2#q7Ch=7~eObBBt!!tdRWTTA@z*ZC-v6dMTBuT^#O zsl=w_`*>h~N(?|eKAyx`&@v<+eo#`pz7pQ=bW&Lkv+ z%)(@;v9?dT{X3*X@Jcu&JB^HKD!Zcs#&>M}T*LYBF=AXHu9Ts;iO?5PhlPmK>a;*E z9Lw?Km^A^?5WMF5`O9-)VNjU9FK_L2G+Qg{^M*y+G1hgk^Tu>{o&H(acET-Ta(Kvx zYlmGc@7gl_Ccn@J%DuKBAm5zE9OJzRQA+Y?_2ip5OVqxPD11IeoY5^lTN-oqFmo}B zT;bx!Oj@r*RDKzpab4YiUV<`q8{O zY@n>C@LC@_-W9{PU_wG#Fm-(fu2>*kf}%4MY5`L8Vhk`=wStM-n}mL@WJ&LvdkaSt z4R5;>KF%YZvItpNxiK1lWG{#cQ=0b%GJ%JTs!hwp5fMt3P?l>|f?FQgysX77=gG8RJVltm@a;omeiEP;?o)xM=TzaV4DWQ_ayzTk0Sk z`8}!{dX_lZ0ZcOQhJvebxipANt$t0ks(m@V?<+469rlxo8Qv;b)Y>5A#IinqORa5D zQ~NNz1Em=vFwZpB9mZien2II^nsKggjouUW(K9w2v%LqLwv4K1wO_cn$8yvA{54eLRx_SghORi*V-^Rx|*wBV|Gmd5I3mh3p%yvxIs z;x*)L1H*Ao%4e`T@Iv^ZMQDe0g%FkPE1# z+2@x*&a_j4Tt={AZ4hlJ-2fa4DR(gj7vkI1_BAoh%2icm~_qH?xAAJLR zzm_$hy0e8#kaREx0twJZ;Mw}CN}d%%v1L_~P@i?xLfyyO*BYw>I+<@h9gegAgeSw@ zAWNR$4-E`+a=Um-v;)AeDOtTjXP{}Z(-v+H-$r3^d-2JlV^2sqO@Hq-lQ~Dk%HT_5 z=3^1ti~T+5J6KK4TrT40P4E1EEwHobbFg!FR~n@Rx^iF>)MMnfW1NhG<_S4Zv#KVO z1qH}3vp#@ml~0)~_{c3Tnc{+j>JjjtpTBd0mV2<*?w;$|xqat-mzud>FYbLFIy1j0 z1^m*pXR1hPIGl)L(o8+|@~HV8biVPp-ZpS{IuEl*Fm-^*Y4lx4Z})4|bhU=9qIW=q z-ZHlU==aHGa67v4tq0&y>=^1eWCfuWo#U?8eUE#$Uq0q!!gF{L)`G$z#3Ro-CBfIS zh5yp+w#yfOj~JBk8)V3ceM=0=&CWH7PBTEIkvzrZNWzN+Jn2khVQ0?2-k%);Ram_~ zZ#|`)iCFbJ6aP&z9@0fwh%ksJAwCTsLDnGyp&4OR1P{zo zf&n)kGPILECcPh~dfq#7mk5o>B_y!QI6)8%CoEnoj4U1)?{B5kHBDZ6hS?QHhRd1( zQdw{J7e0^kKLg+(Nr^RSN2UZYSSSJKk>;OD(6A+$@LBLyI3c^iB2Twi5D6!gUk6pvxC?L z*fz{(I1vq}{3hyBfp{sl*p^zx+h#%_f9!QVZxvQyQc;#Y=`aI z%WGv-l&f_mb(0ythTDmRN;N2Oz07hA8)xpIVHS|BQqi--_?XyW>92j89Vj*jF&Z=s zt^p$*zTjdYNws-rA4Dk}=1wehxzPsm5hX#=u%f>>*Onci{R~FDRlngS4!tpG(q{k< zkqRbTLHi+Ex?B;^O3#Nen!6j${X385zA*x!Sfx(x1}>Q;Ak#WLwoPnnyph{Z+g6;3 zw7E3>7&b-a%$dDR1p(GQ0#kqp)YG>TNVjinc-JzKG6S*the#sw0TU%IFH;V2ce!Zq zEs|f;^p0N&wQT-w{4i~GULc(8UC zXO?|6EcVUX4ux-j9n;e=*$^eGNbb#LoIZ7RoPIVa9s7Kvfso}aILB%L^tm}!g*h7g zpR>;&5rYRS5+ssgKkw`S+ow} zGv&0Z-2k10K*w!Bg%Cz6qB55>++MCB1qjQC8ot39J>e;7ZnE@S!iL7L#dcM+C{S!ns;2GG^l{|=kSMltcYxcfq>DY+JaG_ z1%@*Vg6EygxM?iT*>#v;O0^PuB|E~XV)A7kig&?2Uh0w=3knsMz5_Y}Q(t(9uZvTn zwz3jl$!69sKafl4cf20KA6q$6j!NXs#pG+VzysC@$uTcXd9e}p_W2kYG07g|n`4o# z=Yc@MKxHsMc!)N8P?<5@w0mZ(Wj2Q;b)v|oO3D_3Vcv|_jcA=0wGUEc#(t|Gp8^uEV8fDhQGY_q5tU;p|g*HO{h4POPdx$0eQko4)XMKGA|Cc}Y#6 zp4&;h6oj*A%3C>nRiCx%Bq_Ewnhm+zYT6ZGQv6totUh=XIj!Bl&8M}rnb53A`ykVe zBh8Cuzxbv~Z1^Z|^cWSbQ`NH)=XCOrv?lam-mkt|qBzt9KFE*&hn~s3G!u2Mc9_-< zY{VF81SiJYn;3{hMywE&d~JjaA(>8nYCNtc=DVm{?t3*~^t#~WdUf>Zc!R@$6J9g0 zm^&|%QtD?DZpGtB03X3NAfV%L@flv$(sST-mUst6W{4}L{;CIJr25OFA*FuW)nNbW zHTn18*>7DPmo+XlzsIUH=`uNS^sRHAjmXb1+;Ri`K8;f3*Z{662hD97syRl>!;k}a zYY*wy(V3N3GJORwU*Gi~Gqa~2UEveIz0hp!xqA+ZYka-l_Kr2kxXG?=Nw70d`>4kL z3Vh-E8uuy+$-aLu=iTSq0j#l{8&mj+~Co&st(_71D4_iH4|Bd+oHgAKF%?CBDS3oc^ zr6lD?VBWt;PxfUXiRC(x1H4c#k~mzfA0g7b;7KqXV#CssD4tpTIQ(6AlS(0PgbUCd z*ZZ2|F=pAM^v0t&)h}8-Xm%idSpGpI2dZh*xEK@2I)faFWVwy`Ry+LHRp8EMkL~`J zqx!UlxEMG*ha$*{BICOu;*RuEx*p+q*}Lt9&_Us!Ki^MEVak~ z*(t^5MFY5*K$0&7GQXEd}xqX%L7s&9&|PclTC!c3y-cCgr{RuIWY?=tsLGzkDfpRAb+2^pxjE4{YUB z!zxxQ#6(df!LORND}Cgs`6ikz>7kVGyPAZ@I+0LpxY;^2xmh4G?_OvRCILdqv!#nb zpztXVZMDW5lVDlAdoEx>t4r*K^~d^B+BPdS!&VD3^OKV+u$xbhn_(gkwc^X?>h4QK zAM&sYFX+Cyw%C4SA;8kllD%YX4$BXi(8T$r45W0dWh&)f`uqlza>=J{WqByV9&{?5 z=v3=??-#`tt{WB8Wixz_ z%DJ(vrn}-xVCkrnSMh_L9TEXFO<3nFHrvBHWHdyf*c0hhp9O@hBq&1Q21m@d@by)r zIfHFjNc#+#_^OhtNhhcb!`g*+z%hxlnaTOFn5e;q5J8IuZdVq8u~926_Gno2phNxD zl*LwVhTaC`=`|oHWaZ(bIm3EB?XP{(*s|wcbnBU{m~RAf)jD5o%*zSNlY#c5I`}T+ zHqg1~=;<~!lE$Zl4+_nYK1>vyE_OE421;`(_Pl7rAw%2NUP!`6KVb018tR09`>Wr;Z7Rzhty8)!_orr5LLIlEPv^3t;Yj+ud)$ zY!PZ*@Yw0XoZ}COT~|eaN5Q}*7qDPXy3utf z0}3i^1UR%Zigze#2$_5a$^p+=$!9~EPaOKFtBO83Dt&wG*IX-qf+RVfRx&nO5z_nZ zrs|`AYdGX%O_dMUL`gESHX%VyIdQUSq z+au9DM=Sk62Kr)LJgj)&^8?sU+X2y9C|i*>Wf*BViw@y`SQlZxA%INjsYIsHGB05I z&h(cA@St-KfV)MIz9W)|JQql9#!TH)0fm7AgEzc?LoF02u)U-2uxyKMK^Vg3cw@I3 zaoPZ6=P>)=JIzk&9)fo|a(O(LBT25-QlC-dWiuR54(SNNqdT7O6|+ zk+20Iw&Rl;!bifnd$No}GKnng!a}VZ4LYu|7{~G2!ISeexBDX$Mh%}`P>jVd8rB){ z^m)+|$`q1`Pu#P$5VYeG#%+v~kt<85i=X9WIN1$b|sapJ2O_nLA+57}SE z>FJxR`6uqB=xm+aoJ;o14?_7>7TQ0~LS^V7@&`f3JB1m@$Dr_UZmlf_ zTvkNDL)Uyi4#~l&s1?i)!T<{ z(s96LJ^C;=c4Dbj%1*RfoS{A?5EJE~^y zj%azf!Z8!O1vNJF#CIGTq7T}=+8#}f_upfG{a}}EPJ!aKD_vVZ@OHK2JWK;$=3^N{ zk8Ia?$d!HFTS#ptl5Lm?NV67E+dZt0+2H&@nfh5e7QX($owD3Kj3H@^C-1@1J@Jok zjGUf6j?o0lwQ~}Kd#LNzzoO|Y^F=Px#1GG}t(UWB{!#xpnCgG}lfag3)*RcRa#^*1 za=DVrnr?(2EKOMo3D*$c1Qqq;phDQY&{d{o3S?{)Wcl8@7;o%w;~(_7O{Zw(`>8-G zGxb~X8IOT4GWkvZdVDmCV|Bw9oZ71GtkipsZR#PHaJ|r#F#(q`Fc(eO4E%t*4n4of z_t&ZR@F>1xEKd&f{ELrXpH$ak@V3BzWaBB6yHndmLYkLspGaYASeQYRSJb7DpM+Df zS`tV^_=Og?Y8KQ+;hQc^9*c^vW|NG>{ZarEuHs#d2+sCceXR?_h!c%kD3yyR{3UJ{ zw1R2XMOusBk7tIM%}%q(-&X3HhZ9$`_+8MM%Pa+7pu+9^*@Y4d(>DC*V#fx5jxzJC zn0`Ed$s%t^f1;Oqhu(6IA1}~UMA<;R8pz; z^%?r23Vi72AQ8-%U<`m#6mIB1>|xuOl+p_ZgoWk&TYPuPfyJFw9z+CIA5VCQvSgYZ zgdr#BVMZw(cFyjBBg8Cx#kaJ7gCT3e1?!s77W`G;6^La3i+7guuB2~hbk860VJ@}a zx+~5c^lyRm=sLSG{iYwF%D>5&!~ci8!SNqwF_BpOpM#kFH-r0GRGfd|oc`kgF1Vjt z7e7b=<MoZsSj-kW}+p333NdJHQqaata4ibl;iiv3N3{3sD9Yf}|KqKMPW# zP4XGhKd+zs7uXI0QJ0~#5fqnT=nfSDHZDf}&=|*;HO6;vmpy^zn5!KY#Q3N3l9| zFZk-P;;V13{=a<}w(cc$^YxKv09xh$c-budRoZIG3;48agM?>}HRJ3KDRn+w4P%EoTsN^7{Lq=%H@f(|n_{qo?n8z!Tu;VkRrXN0<{73mJLGru;3iz!vOdr=@dqBtx-W1~ zU@_i*EpsxFOl1PN&Xh{vKV`-kqT+|9FTPlkAZeJ1wHKf_cZRPY&W?^aT7QQ7`g?{4 zkYW{x7j$SE3OI^W2aZBx*AyK+)lKi`!zx)_c1LPk7Dr;-Yj#-bT;hBO5}*W1K6VkW$kZINeixA>N({S+)W5qa!?FS@=wfhf`-N>DI+)ClaR^Wl>{A5O5e ze*ne68?|#_b;~(RJ5AcR&51@c>Nvwi)qR;&zhf9G4-MZc5CQZGcF>x)_f6WG(O_r!csGG{8CyoBgHca!UH8tN8fS003qJ|rVkE}Az=^nbiIMD^Z+-2v!MDzL{ zf1E&kS!UfJ53f*?8>@hMF^W*}^2=9v^>a@b*c{DLBUT{IELEBax*|g>B%?pFC17Q(J}RfK^Cc`%#O(I4qKDVtzOej|0mbOA-ClZqe=OR9mL=_fhrVr@ zISM=_r1vlfbg(K><*;{GwuQ3*(6T!0mLUfj0}E#UF>k60-U&>FNac9OZB?LI=4!n~ z=Y8pE92dv`tfqgmKg3q*$(yF#m34LpM%FEA)gEj*sy^%qDt+m$w?iZEZ}sz6NpP8p zgD{D~gH%gS2EP$dJqjF{L>{r(o}jinQ;+c@m#ca5@uMR z1N}vftlClM-fx-F;9+u|Zsi;gZFx*nE>5{%$jQeXAzcfDPz%~`Nz>u!;T|91kR6RYt~#0tv!pu~l^KW1gq8WGeV}Ix$B-3P zJuNk!tlrN*w?#)l5gH}9qT&QiaykxN(!nfGB6qsh*`i&OUvR#6ecs*e3UGZ@*w+?& zQ1IHDv7g;(&?2`7XPW7Mtk);~)%v*Ak{*9ukUzDTDx5?CN^xgSoDIRJ#tmiE3?u{E z)&PMyUf0yVAs!-4SrQF;_6gzv-pakyoSjz}POy=xnK7~?l~qMgfL!;4vtg>eP^Y2^ zlPa3QlS|(qHnE!h=KsT+S;h=_+fB-(B>+=`lt(wWYGV$al=Eg3PvB}>xy zQ6mN}Rq8>Htl5W^^X77{{5ICUH2v_7xa_N`+NOKUkjB^sEWa?-9b&+<# zqFDGTAC?x0SrQMSrB~-UHGrVhFzMaWG7-QUJy}L9vB@x@2ZFZ`Glm?q_5_AGr`7;= zmv$2nzl=wJjOu}ZgKymo6;jQwI2e+Q=NdFXKJVn>CPjwnIGWvQV#4bHRUKF3d|4!! z9#2-?kPRgk?;~Mp!Y8*15HJpoHwR?eDA3tq7ITqP9NDBqpl1I9wQ5Nto&82tb$;}- zS-_eRlAKx(=yjHlB8R23r?77-A6G}tc$7}nG1$1h)b#*=R>x4z?zx{6i4ep^l-a?D zKj$(21_PJ-@HxC}7-oh8hooT2d!bhg_mHs2NMLlt-6YF{C9zi&y-%i2Bu(Db*lLip z>824FO_w({y;>s5 zKu8xa=#>b6v1pn;ZgOEGt*+H7+{^KPJXkr<94engy%Ncs>#$f4sZcWQG<}65b9BX^M>A0Bv1K16+fv06Z3bAx2OO* zw1AsPrR$eHouX>c7T{A?o-jjcQ4(^Y2Tqo!0xTcl9&K-ShSY~J^xQVPOKx*T7%KYM zl&h?#=VRIR4FI-N7{?BQ=M3AZ=t*oNqXhhodeoQ(o&+;bk%Qz{RKm`FW6ZWeBpFh> zbV&+-qct@{C?Np>La_wIAh!)};6m>qo#rH+Ctx%}Hh0JDjMiHVfR1NiQAZ66Xtg)^ z(9!jP_YeKi4e#lH7`B*>j6b}Ub$&^U=PeqArkCpwgUcAun2F~Y{8e?q1i24hu62SD5&C@YUVYlyFQYBopZZ3x-?c5LKkff}x!&$k?h}VxVVRHThc?&!Ts>i2N#TB#rRVtdZ*fi#z>GQ9z`e|o_U@9^ec3;Fd?p$9`9J4h^2|xn)=6Ga?#KRYs8ymHjQAu- z|LWf_UkA~A69ZT0V7r>ewE|&p{P$@(^(_|sX!@F`K z>@Z;fE^3h#bnl8T2NdY(uxJK`eZgYvGt+_vPWjY=#U=s0`Frnw*7SHVftcCME0HIF zYow7POx{x$d4|DqMsgAzQz}pZu@*Aip*z}D4rDkxI{n(CzMQt?3&z3Gk#)m{HqMxo z40nvaiy#z7OInizPre$#12aUx87rk#*U*!N(AYE7ZlPh3ICjz>aAS*ho)CIURH~~& zt9_$(4|P*-u7@Xo#{ztzW94qv`x!e2Od-ZkfJ#YsuoEPwTKw)~^8Hrlzt?bIf7A#% zy;Xf85$b%%pm)xP*iSm>YnR*Amn#h~x=&u+k=`w)T2Zm2)ab=Q!JL-ATuAxE5OPE| z>*;bid?~vmS)5YFGya6S$TJg$PbW_2Ny@9_b}SGW7)Km`eNYj&H3`lHkcGf6xDxxZ z$j`s>)ego$JeY?2xwkV<1H7(QKY>-Z)_ayBa!WzX62~sJxLr=3COA(s6Z^0EmJy8{ zEnr3UT0n_0$Bd~?e4bOP#YFE0d=a>|&17o3T-7qE{-mnb&D*=GYRy<}072_#@mj?! zvL9qlnH_q6pfrY9Hwn27`Uy60kv7;H zt{jM+7p35y@#E0jb+QN!u2z#-zkg0&-8}o^*OEdD3!WxS9KVd2rr#6BbuvxAFF_H| zrt!m>k2geoOm^JLfOC`lQPtn*sp>Ciei{WuxiLn639@ZAdR{nBlrj-NRrph*-e2u8 zOIjEnCdlm^Uxju^#)z?uZ`W#;ks~lt&TYw6C^t$6#?G{0Mt`=9NHpaDkowFc$eA=p zOpcY!x62jli7J2gNU;`?2#!i%njz~OJ;VAcvcAzDV|~?AQWdlD+l;G9Z?o-+)?vZn z6V+K=Le+nsIOGj{HjR(ra0oU`49padUUopbD|}~r6t=w!C~QpoFr#-Ynj>*dr&Oh9_aF5ggzD0HsK&7%~ok(JV=0)<4Va%pSwfgnxMuQJPn&6U2(ALxM zFIO_zl=pX6f^XVxhpNIl9SH#h6N&5Mgee0=?fl>W^X2ztKUBwjXge~@lV$q+l}VQZ zrHaKe87UteZ*Mz)5*Ekt#5=ExbDa<6)mA3lib8j@K=!e{rR#8TGjF@n-IYz*U5RwF zzyBSv^CgmCB4H+FD<_g?#;sBri+K`lgtV$wsE?7L zzZ&`6mwk|jn`N0KBago5s?$)lO;COvGbtv**N3VHaa6Wx?Gm_;`DPkx>U+A&uOvzg zew!kIp_?nnnPeW05&*`ahh8?o!p#ruuuNn(2BthxiMJxqYS~AVk zQR4T1A*JG_PFsS`SQ*B%*td?ualqiR%l8(Xvvkt|gmoawK#zdiMM<}3z-i3*nQ_Pm zV@-Yx3MxzrQ6)z)+VgNa523x4DVz0S?;!{5LP{ygjGSPCf!&iB5|)#qM=7jeRfCCU zM0j{*QxIGsjKRe$5asu7tZIt-yc-p-8nP9CBprv49qlLh zgvu0T!>TyYxb-Et_UBt%iqnd!L<1v%Tdbn+H5xwe266#-#zcq{oOdCC$-BS+nhel8 z<}>2pn#r|@J?h2%&3EbC@Xfg|Z_fyFMvOTeM*r11Z^Vau_piLL662G_W}69nTIB$L z(GdK>1wCk}PzY;Wm_ka}casvBstq__1=j88rG-(Lj^R)>=hBT*FsxOWDPhH6HxRDI z3IUHdU7M4`!owW~?KQnQLYfR@xQb>JR?Mo@S!HZ+|kP$H;Eh9_@fq4rIB1*)W?V?JePa zKRzUU+G9In5s{DSn(Iwn9c^dC9qQn_YJYG;MSHfPg|UF(EHr^6ydt@g#L@!91FGax zTayps$nChuu{E2f1SU6ahno;k%_AA=%H}$I+zrT}!2j+7F;(op*j+jz$Jg zd;WyR%|4#Gc6TmDfhJdfvC>g3v#9L*v0tF;5u*YMh4ax346e}~8%Zos#`Oue4Gwi{ z(AdxoG&G=zVurs)D?bYc~-p7J9eo=OJdm3DSf;kzz1*a zsBoBVTz+)#J;&f^w0&3YMmG(c{)=_(PAdUCPxk(p*H`-r}063tr5jP>}E6?S9;9Up1u zL6f9YcNUNZQJZOhwW?X3+~NSrHbbz-NtsCH+~au1LhkAv?HC!!M6pa{)3FZAG8M&| zr6QgVbyg%6>y@1j%?~s2NFv693}A#vt!c0{##_9EDEZQiq~e&RQanK()Cc%Nqc>4V zF9`BraRTP!-25DiJUG;vPp49aw~^Et6VmOp22h4DfzgoU z%-&F95!pJc{77qtgUw7_ZuSTsd0o99dD~2iGBgM{_iph1rv?ADmvEME&bKzyj4B0G7iA7^v|0ynkKw_M{^Llmib$x z6ZC$GVu`8ddO$B>La7xw{CvkU!`(r#GEhMX0DqSkg(IZ=V2@K6m}h+vVh8C;#UIB_ zK9SphRzOwp0xyCte7poDk%9@Gtwe#8_n0W(P68(|%V?Si8 zXz-3KlS?~a@*~{X$GuWBqo=K3knxXt7s?NRAu7-vm?af)CFrt^;~1R%;WoyciP)w$ zooJ6T?C!jel9?pM{ei@3C-KSeW?B+Rf#nvnej9Wg%)Y)BpcWX@KpAYm3_uLixpbC} zy^D&I0Ie;o;>zHXIDUfofJL78V7-9&)2uJ2z4W{zo3?TnvM4k2k=qb76AHsU9Pk`} zP%=3ehcX}o8Rk=EFtZGZ3Gf$;8!#>ONZ=sGxXpMS;3$Bi$!wVfMb)Etpo4hey8x_6 z=;II{C%#oOgG*ixY`z}v^;QsUuKz!I?g zv6(0Fpl+Fk++Rkw_=&nD**cU`FBnlbYl0QDc^Hjot zFYFF}{eun>TAMdN@@NMyp{QapsC8$j9wTk+H+UY^(GSq+1b%R(OkzI;ibOJhZp0dR z{2)lCjqC%W8vquKHc8ZF{KELhO)}7diS<^_U;zfOp#h+xd4tcwj_ECE?D zp<=_#<&TnjJUTa_9uVIzYHECc%!~1S-q`wjBoPuH@K>c%L4gN%SNPrQ!dV3(~mQ-c^Nb z*R=aR5?n7>MhN^cHpzD)yVw@1YR`SpJOEvB$U2tY?aa>JtbgkCAS-KsCTFz#G|x)y z@yg1xNQkB%x^qEID-7iBMNXIg?7s1~w_zjc<=4Y+gK)ul>`6J+1HOzYv3IJ_m8WyvFS=4_d9q~lb$;%9`>Qg1dMl+mRCV3MP5hj`Xxtsz-c3G~^fd(U z(J*+;=~CbhCsWerA&gB9o}@pk7Eu=&J-JtZl1BQnMjuYOpP+O66rI(qbMV9@AlwBTsU8x4M9B3m@L)aFp`PVr-#9#O6C6D zeN)}@Hk*-unV(P?iPKOZPWvs$>A{q(Wh~TOy4now0}BUy`;7KR*kJ0KbE?o$krr;9 zADnAhB$C__m0i7J#aw?lnW;RmIO#$~3bqi)Q~l7Dr=~(CYmYy#ws??dQ7q>T{$pNN z78RMWOP319k5ZjEah=MoJ<2313fRy>`D;p9bbZhw-QV1s!N7?dl)6~%%Za%F!T|dD zz#m6XV>_;znv=1mds{dU{cU;Mw9RC@k!a!X?P!L#EP#H8s_%ck6G9y?1DU9;oog+D zN!e=eSsw5^OXD3%rrW*HTf0BRDV({?;B2xe5%%m!wc-R9f9?ld1}R3IqVb~^gWLY; z%tIEjKV%U{i7Iw^lshX7lZ$zc0qYA`-(iz7TqYEADanw@mm4zqj7p|2QAzb8HYdfJ z&*5}&6z3W=&8L5K@|fu-=lo=ARY?>lv$FlLp=_W+c@b#aXIrdFfTyvqX*XNP396mQ z)oDJVNbA#ljoO3`&&iYfE!(lT@cMQ7OW(#IF&WgHta&Om|o z{l00PefMXoYg5}{CU0QtM!`Sgv7p^cc+D&I1A`DJV*h_fRNBHV7a+reA-I9&gZklO zE5LeiO=&w^$kXH4RRgB9y_RH1psDT22p|vv`|*mIW=isNFjCuBqyQ|L2J<?uh8*V0RVBK;HrHx(OXk zuE<|+7)tQaMU)F2o~372WjI%%<;$FL`eJ9C{wi!r$v*mQ0_9@}CIEngev}g_7JM>B z6AsacM<`E(sBY=uP@Q-Ws#9=cQvKhcx<^m^WJt z#-BGaQ6?iDE1&-=b?gIRr&WX~fKJgm_^&SLRJ4#zmkfR>QVgsmRl>sEU~H4=%y2F9 z{qcW+TPhSSY`C?g;J8t=-ZtcDvF7%{buDjO1h~BTG&rIx*x55eWVOWI4Bn%XgQqV(@}rG^mR0pioiu1MH<-C=i&8 zKC$+RTg#$xOD_}z7+TJjf0}6)ZH%LgBo*jXh_xkR*(^&b>WKjrt$mZIV3*S^7uk+UYsYZ--ZtF#{b(G$El@D9#Q+_{8R%ps z1z|)NO2P9X-7mrE6I*&%`gj8S1Om=ZLFAF5;}1+?xtV5ADiVvaeJ0RMp9z076W@p4 zY_SOg&6hKYZM?M{@v@npo^m)ffx@O7;u^!4fyNLX;cI#gIjD34qwn8Z060o0F0)!e?h`?1?BMFwG!U&z>V!*tA z`|F$QTmWRiE|fpdLM`ABKXLOW1PN^t6ukP#m7Y(a?{cuzU^YhHNW$E&ruN}FO-R%P zfP_2fgv~L7b09N6UYfSK9p+<7Yyx1*⋘o^R)p0n&p@@Xln>+&31nzAzlRR@tRiG$`{?ggWf?E_X>VqZ*uUPWHE1!hD?HP<)YiXBmCO#hQG(+R%*2bF; zRydPZY&h3RmRlQV^|yah*>p|<%W)O2+Kpk;637jlNZE>SZyPtnDz0VO+6sgcP)DJj zlN$ZJ)Uc)TsNUzw_1cxcdXkvd4+ppQ{ZE9Z0-}ZlL(?2IJ^2u!DFvRNY(=QxE@R>4 zleRP2K&8N7W}wZMlN7IAeSUNGqtzG*(NP-ZdAx(UfG*orr>lQ&zZbh28bR2i7!Khb zk)C#1z)o?A?e43qzw^E5N(f-E6vCib$AA#Br$qtcMJEa~)gc8HKy*KCZCOf!_Q7S% zc1T`85L&!Y4zoZG!Qd2tA97_;P#hxt zNcV-q1PX{|GTVl>G6vQcaggfByi`XF5~5Nv3%an}^s(LQ!qy+_f3S%FxD)MjoPb{L zTxp)nu4{4sQ0cC)7sAw;c4!T5{L}q$;MWFrWZXG~K0|;16S=7Nfo&3YG~R7w`@rP& z{QLpt0ubY-3vMrPb=_vnanMCnB&)3RQzfb0SCZjq{;4XVcY&vQ1ED zIRTwQP82h=;gC7D7dY5r!(n09j`!A0XE|2zr4mhd4-o8lZ-1@T2cJlK4`OZPkAIUgS3NV*ZkR!ctTWy1;j^YY#xJUAT#+*;riC2RkH%eh$= zvUz`UMTEuqlaaKTu_pRJ+%#khfD8Rani^UJ}_s3;ZLGD7~uG9GnKbRG%l`Lo#(K9I|T zS33CmAlYer=^-tC0aitL4*{@ke{-G1d(wXbQ%)x`C!28yhSDrh7><=g!-_jkz40(0 zm*7k!@q&YG6j+#Y>RDSb<~?O+VT;nhy%zg|wLUKo<5XjSv*X3E>Cqb_m~@BHds| zMC};Py-N>ZQ)dgP;I4A&j|QW~ryt$*9oZKZ(;DFCI5aiJnW~umJk*jgf?v+cQK^5Y zwLr;)?*h1zQgT$P`qLQwrQNqnM(*Jn91<* zgbm;DhR>Mw%V@p;COjh&05PR^&%0rCps3?HWS9-p8buWOjAc2dSNj@RijOld?S$|M zfr3Z?C@?%z`|ffwgB816?iV~|@sNLVV%gdO9~#s0Lr;mXQ1B|JZEo?7ikj(q#*R%c zCYKJ`Da>BMI_xdj?vP1Jy9XR&eF7}=o|sy0Wydx2`2*ua|Ddm9LAegl=K5lIXcE)R zDHRmxrlXl$Gsx->of${|afO*~S*ptHpEI;}FMwjQ&YYytIiZM?jkVCbH2Fk^^}OACkI@HsGz zkfEudB|&4|j1`!Irn~U-rL@;mQ(j9OM)O7Y2GZHeEpQl}16k*cP}-f`YOyK9@O znOxs9Qa*SG2ep=4P_kx%4s(Bb_w?A3jQ}d@n(AAp zBFK#y6k;_f{sj2N(h!`5R)`NSLs{9Up4h~9hfo-&`HdP<(!Em5S5JTN6YdBJf~V#> zQ?q2A?W9e|zg0P!F&q>Vn}BR#DV*EfN;EDG_@D|+7TrEPi|te;Ui!YWk{ns7H;B@IILE$Wg!dDGFsQ1WN2F6(#Gqr!jI8ZF{lFV8FI~Ut7 zWHcPAZ>K#kqouV-Sm4)PR6G(Sp<+c2h>Bo18r&Y1Zw*){OASGLh|260^VqVt<>(v; zYyR%|%U&0+@)iDynywmfQrF*YYwZdrzJEyAPq${a!4x9?+dOtz^EDPt2|yGhT70g5 z&{~io##*w6GUk7~ay{RbLqly!E=`;F+)|^A%_`?!N_eAT=m0^lIbYhbd23r%C&PE_ z(BUmPQ7qac$Ko9zmt^0c_zO;SRN(x zvM7$%uk7YGb)G#9FLcT+6P01o+SAEX-!;`YC2n?W<{)gxf&V}>l#L6((5jEdJe{0E zA^_BDh{)iVXUoC|vS1l=dUBHi%Pg-x=e@n&yfnv7H=xSjDA|5MbGr|4Ze z!n)ZYj0~{FV?g#Oq6IStApvIAV*#pfBgrg$H}d(-)qenx0ESP5q|ft*te|FvkWPcq7=X_nj%S0dO?!92#O>qWG&Y#SSxLG ziE9-7@15b0y6oYevn^nV(;Dr?#oe?~A(rh_gKd`Ny73FMlp=u^kNYtCx#(e`p)jjNv^eT;1NJ zyP&wqQgIc_GXcj>ndT`?c-!3Wq)NBL(PBe8_HPrtEgb8Ys-JQOPy&m)$$@0G2^fXe zf#MA;YPefHvRWcprt?5M>3?KVWtaj(_LPUQDTk`{tdG6j6Ys~Or>-KlTaF+g!y0w_ zynisA$d*R2)J)73JmmfupUU zOud}3aV%~V?sui0ek_mFD(L6OB#})qj9pPfQ&DGmY^&1GXb<#DR$Gr297YQ2cYlBM z1Z(ido^w0cW~hofcE%lEYkH}rGnQW-Qi4qKN$$@8$8eQ7ha1>ePNvmO{%gLW`wCfkY|3F7y3S?8hyhc*Ph&h_Z`Ya7%eY2^0p;CXHXFLs60$_fa+$8>_SUJ1^7~=Sxr%=k zr*mzA(Ii6?vQAkYnQu%0L4Tis8!=4RhM7E>Fnx-yVxAsCkqHcc(L>jsqTxo)j7oncFwMOU4M3qIFXi5iHzj(<%>r%tnLpqEns z&zJFk48J*;(L@%s!ibetK+0s^Z;Xb?Of39*Y!%oko!t2IL}FlZ?iWc6YCB71y4nkK z)kPG_5==^Gs=FxG2?owCY==pYliZJz>o@)~8-K&3H|bh$pr6hG)(WaFQ?*tQmuc-1 z&9^)HG5$o^O1z+2Qh(0c9gJknYX-=ju33cz@8}0MO{s;v`&cFcL^X2F(S2MIATmnT zB#1e4iFk6w7l_&qT~T4$kw8>iHDx{SG15*TxNx3L1;Ihb0)l7+;CPOx$b4LyQT3mp zJ2msvbK6%G&Eq@_XWR}$ANAy!1|88Wv%(xHicf->G+)JS-#f-yEf5G?#OgRJ; z2m#phB?_?Z!d$<6i6K%$?Io@Q3vpbRm}{lt9l1@pWz4@O%p_(J1(BEcEZ7EonaH+} zJ_=Ict8{h|Tz|XU)Ys!O11ZTXHFHiXA1ciAaM@zG5<27yJ&xO($fkYoVqlfAERyHW zP^B1njTKZmnZ`Ct0Eoa;S9ldMY-*u>MA+GZbO8h*jsTqX8u`V9H%kOnaLWo3d_5tK zjALjH&U?3@jDsln_&jy!?#Wyg=H`q0MV&1Hgh>(&5q~ITq*Q17;U~V?!{FB&&J-N` z*^!>6>Oj5u+s(JWxOO2dzZO<3eRVB~NhAfAjmL!`(Gfin5hRyuPoZFz2KG&mM-p8Q zcLjilSj33ct*_xcMW$vj=kcZTIU%~HJ1VX_7lKuwI_foY#j0t(mg}0SL<4YYvy$sa zx!|>61%K`*fkDupS+X*6SlBMf!C$!uYk8efeFS|o@AvAjQAo+bp+Zpe|4_(jtxJV` zM+1Xi$;)!s6ghns1ve1T9Hzu&lcr`FXvZ`Ylu9P=s^)v*j3_Rwkk+}PsQyAo0|7{Y zj;l8cE_6Y5cO@mAd~{A2_*90{#9Ed~%H*6W+<$$r`UvTpkKe#0fN#VK97_W?&&SHu zS|FAOk37~cbrjsiHuzhFvAP(lIhLW`bJso;4^>?aFVx{f^q3$-238{Uue`uZx1`LZ z3fCQgWO;gt|7%$)r?5JR)pgf?r9SN2CP4d(Np%JblViy}S-r zO^FBdi?s4eaFfZ2!WAg2S8b~DyM_-!A<9%a_r*f5*E?@C5HgyJn$4{8Jh{rE<}6d@ z11y@^Ov!XgYxmKRUmAcv^*_|^L^|0zr+;F%V% z|7+_xDrlO2R(YXLupg{s0oP*dUhbf;ZR}@YGRn-%!(KGI1B+`sCV>-YMqEf8I3LTw zl_mhn9{hX4`q{(1D@-p8JxC_JNB|55CCHuAr_Q1~hj)w;ZazFTxWWhgVt>JSw@88g z!-Wk`1a$w{=gc>3JiolS&!?(<>SJ%eR9{IKvBHHJDQ4!{UKexlfHQO5>9Ci29{+acd6KDo7%55o;^9p zr4HoI5?yU*DnJng;Ja$omw$k37b|1A>WyDJ)Yz3PJujiQA0LJeY=StG($9y+>MkWc zs|AAS+h@v@Pz#`4{1-v|@l~ljR$GHTTnTx}PT~axJ@iiN%2R6lC)8AH&wi+(-&57> z9ZrJ7y7rjqMgzjh`DI4rIYb`v(x4#X?cHNHK@u1sE)!NnFw30p08%J3C3`zo#1yJ~W&ed1iLjDW3#_AkYB5?*7ndeRA>k4V`V9 z7s+fpOJ?76zn@>c_~dKFW;7utF?4ouIZIPwxSHw2kVHVuX7I)Md!_Nzt8IH ze}$6smslg_S<&vQ<93HnY@WBi-PM97^Xgb^{Nn(UKyAOu`qxdqKNPn1m2DOJw5@;J z?(E>}tSJ7nkaFJmx0jmTF2~_y61spwk+m&!0jo;z%Nr>C z>VM+JZ!d6Dk{O+8Hd73+2dlQ;zi@TL7(Nq{q$!=%c6RyVA2+%fe9v8Tr5Q0Yb|GM= z5-LMir+tuAU=e?&dKya;yAmAaNzaf6=cAzq)Ax|xBFK%8B~M9`=!dMxSjF{7#bIJn z&Xj871UmPEw4AtXj4z|E{Fjk zmz)7ugdgi-k-~?IC8z1!mf5PXzMT1=y=}A2b(!t+b>nLQt?MJ8C|}TdRf0NjE}`{= zPSO;2M@RJbt-5#{t*Gsqkqm| z#TQlaZoxpry78*Q6F>{sV_mtiwwzO^+l3{Ir37_()i%C%50)xxE3hc=$ifCJsGJWr z!8Ock>vqEfsNT+e;jP=3vDKuMq^4V`HHaL%-Aj5KBO3)}`7%r*`kW}M@GHeOCx z7%*S(0z`xr0eS7_<(cwPC{xgsFn=1_t{-i_-L-d$CCSubP~Ocj9x~0lim0-3qy^aga!@o=HA>gl#(ho zah6|2%MW7>EI(97%MZmoRM~93^G!GT-j5Y`;*1_m0}_zVmZ;ni?>Yh7MO>qHg%#eN_i{8bJr+9>%v#^+lVL~v9$ze6@#)~h5H<<8L%?M!pBp~H z0Qu4#d??agsh#1WPiuID0Y;tDhvBC>wufW;RcY((^=MHILm&yyzx**k`ntBiJr+iq5}`jdicrwIX}5NZ|8y9V zhHzs(k~0%Pf>Pi;rx<#AZzg~SCEPp=L|1j*+KX3jUVr@u2T?ERp9w^O8YQ|26crTc z{D%P%P@+_%j{?yT8HQ#b&5R6moqlj21!3<#WR1>(j|US^0DnZ_S3Ztc*~v_&Hm{8XejGP;z!SFme7N71vV++y-jdsmVb_b+9?qP9G0~n0E~vd({UUwzqHM|&JSn~CI?ioxUz%5#SZn8E7;ych`IYK$bV4lBgIg)>)>~~$CUA5_-;B3 zET9P+#%8h4c7gr+avz?>VMBPqEhvo z#++$zOn}X3%#ol7^&yNo17FPJ<=umfc^|reuzxKFGB2sT*OrT3F-0;DSL3jSlh-U< z0w=%snnm=tg3&1i5DhL_f`51!0h2YyI>IPkh=&{fk$b^}17A8+dD%8ork`=J>y+MY z{5fVp$n?)){G$N(T7OJtktfz)s;LW9d?BMNkl`i`s|Kc8s+etoFD4;HQvi%GCzygZ zK!2-s;)Nm-_IJq$ry+dwzH>AZT5095NeqLtD=;)8$NN5>A(31`W0`~lpiAdKNihS) z$+_-tqwzvCW$^~Awv97&*eEZjom~oqvA=i;0LJcvX?D0vxESwCK()~$RG-kE6i#Tv zyHcJQmp|e^^mmO===*98+1m4Nc*xKT_I=wf5Al5QBpqTlcw@QG z-AzCC@2&}l!odyNkXcB0E;OU4Y{c{0Szw`NE z7gx5uvUt0T57hs-gA5jUcy=rR3bh3fy0@igAyDBVCXz@&M5I%nE|$W8PX-Nkd4FE` z#$zTlyK)rT_2EoK9-h!uyD>NRw<8dakYaS=_W?<^K2(KcB+R7U#-~F|3{RKGavdBx zJpB|F5FICa99Mv~haOMPWc|^ToPWK^@TWG*ytVMnrCW^(th=fq!iz>NG9x z`_Ep#e)B`%4sB!w;Qz8B|Mv-d{cC7e0NBfHXj+Oc^D<;Ap#KVlBa4X)!IAp3%3HD> z-sRbu_K0&zQu*Xb4j3F2srneSnL5AIr_yonzCHkLrjipDRp9s1=BcHAFn3N35eYw^ zJAd05ie^g7B*r4{XU+VSHGg*rp*MMRA6Kc$(C9K|?(`9u-o4)zC864&9lDPyV_pmY zzoE*=d+f5Ym_yaZLq(A{Cy}baotq~k&w!f#bQD7;dJsBMUFalQZK&!py(Y0k1%QX? zXY?{k>YIG%DuzHycBie2uu(3})7r+!Qwx)TM~ zdvc1eRyO1@a_!9GIDbbpdVR*#JU^G%3z%zv^f)&58#vb7lj5TYqn(}2n<>j=z&rPL zww$!Z9Bi>3|K)+lOi@1ij{xt^w^*D$-zJ8rKBj(;{<5?5_b!M?u+(zI5*sgFcgVmw zw7V#Om=-E(jfbh!um-98|}!*w!$g^q&Jd0C<70F4->`nrFaXz(KbXm%_@qtSVX zMK!@Uj%z{<23U_?C7|}Q#>g(#`@Mjwaf+~)!G{vgWT66sDv!zrzL93jK`kWayBYUC z4%bMFQ7hn%{{;gzamv(}k;@Jf0yQ_6Vc-E20yQ$1K_mkze_BhE+qeXng&l zF)uIQzY~jHd%+jG1z)_q^Zn!H#mhIbTnNrmo{Gigc9HUh;VI)9YMaF`%a2k7c0h3FZQn5rOi~Mlm8g0<+o&*C#&`HjY-Bj38tbXNZmf30=s5hh-VXnDI@%Lvro(svJf zQ7Lb1))jR{(k3$s4Hk`pyu!~ovea4{SiV+^wNNb5DRuo*U3Kn%} zfWBDWf7xbM3lcF>;s?9UPGvXIV0OtyGR;-cKyc1yC-L3fEK!)G&70zgJ2bmA!i^))wl*&e<*1^GAHR4rDKn9EyudERaaysTdiZ2 zz%qT;V^eQVc}Equ2>5nn1Sr8OX^BwID%2t7!#w?#H<`B;4lWLMjb@$p3uFV-HvYM9k_{upQUdH0t${@1L`f4u}Yj!XVKiY>5l5g<5Mst+wJO%q31duQ4 z2094vaLFZkHvaD1&CTd#-!w(n1vRd2>3c`49fDAEI~O)o8Uvl^(LJxr>#S+tTR3`6 zH=-3&v%m>dOo>TU_V6x^KR!m#e;Tmhj14it&LULGR3d{OHSN)i!V+AjM>2LiZ0B^7 znwdB~M>Cus4m!*Za8j42gKr~z{@jtu+qyYqUC=h-_k!P2F~jr}`*7nJ!jGi*K_bht zcA?C9h?|q>9sN#Gw54CN(06RXP0>0c;s8xZ$)uVPg}Mn)Rdr46c^5?~e=MDQmq#&- zRp%hrHCg_vhs1N(^-@=w2R~Yg1UO8U6Au~IFA`vC5sLr{o{6ZZDU$|}A~r0602tr{ z5GENqu)Z;1sEWGl&$yF;GJ!XdV~8~ zda~|x3f^KTk!>5C<+^B3e_2`l>wXrG+*Rs_S-gs4X3$B_xaWT`iNC7r(q`3fPSxw` zQKCM~@i0>d$5*{v7o_F^)R-PYPpy6H0@jQ;xbv#Gmp33r4=dpY-~gqubF(Gr80nq0 z%JJ#KV(9bYK6ebW_K^=OcLLlDTu*fpfDCf*R*E$k>mH;5kpZyje*=_@b7Q`T5ixeQ zT?0f%B7SBVRHM9m#j^q4cKf|j6A)1nZXQKEpqA-lVfZd6Va896&`)s_uKrN!^B+9E7yV); zc=Uznr=;i1IEl{_f4~%drh)ss2Y#!(JW=Yy)rcV~&Y7Ice8|MRG?l@(EY7EKRi~C3 zf!W!{UuUqM(WeFKV0{;t1%a3{Je|0;g0kVczJfVaSNUg=} zOlLRa{_VbQy0fIhG+Gd9Q>=)dGq)`hL=M>p3IjcVi_Er6VQEqP4Qv^6+wEnO{nO@M z-F$O)8*V2uPM#hpJ`C*GXMM_gH+GvoO&L<&v(W-AB8LRrJ@F#JEinJ*$6p>Uo=lK| z_{IJ9{)Bs&f9gPJ(`X>H&|0*!x(S!5`a(qKk#iuJA>c30fS2{Gs0dM<9+o-{>27Q$ zuX4qK`a&;^#F&EB-5 zj-`EXk7bc(vqur`aa#4hHjhIPHiuW(C&CaKv_SW1$s@H?aABOhjkqH+x^L(EtlHT= zUHEE_g8lEG_&Fg!7KW$m$8~9F&wu*i@r8Y7e+Xi<;WC07X(C5heHm^Vlobzmo9*gD?I`PuN?44p9ZKbt~ha$pPoZZ}+J!o>|E zfBDFq`>foqZ;DN~pEsLOz_4}CmD|40u#A{RE)&I+kW=GE&afpkoRoGo_y?#1k80Fn+5H6QMQF+F5=*c=xG-kkR5@UL}e zXUQLcOu~o%(P-!`L{o6ZuMcP~Q9x(_f6wG=F4q{t;g8=S`~?DYNgG5z$k|;28k~rD zvP*YYr-x^+t=A~bbH)Ur<}OcJOBFy9xL-P4)`s4=GzM;a@`pXqOhl7BK)sz+6v0qG zs3-o1!59qhJjE_VBA9{0yf&Jt@Cszc7h1TC{u>O%Nw*4RZe(+Ga%Ev{3T19&m!HcH z1($6!5*7n8FgBOLs17TCliaouzUx;or*Nt~6kY@gJ32(RtT?Hp9C<4`NIq~mm|aFQ z|l76~PpB8ny#+oXhz z<#{4Y1x$z4v-J?#3a*4Z~*FlxMk6c1z#r?TV7L0scq~|7Yn1M1WX>JM5*)!tH9EvN~p|8t|p7Uf8z5t zOo_-;sbHdiGUL>#<8LT^eS3pC>G}dgY=pKm5BDCAD!Nc^2@yl64^9WI7JeQtn;7~Dt{*F9g|L3~ahq1ccY3~*2BxbYNK;m!cz}idY_vox-mduLAal%i%;Q*%pAF&VyOGZ0917O1px~z zJ>QG#1~kaa!eN?iZyMmCM{suYv4mCb>=&nUY;L>WHk$pR@6e&&<3GKzy$66~2gd+p zf-&QN`g;Rzh@(gYmee>Vx?LN{TD$cHV$=PKmg&_kk^*408{3$M=U{c!rqS&<*jKv| zps>zmUj}`sdSk_Q1lp;k-rA@B=~$V4igY+sH7qk*tqa)G%bC_dBsMnsEg`JcZY`I$ z)0%8!fvpiJhAAUDM~aep-R!y>-9PV+?WXE~Z_lU_nx6cNs1;>WiU~jthkF?2OPfPE zM_4kFF)HR6FxwRAqU=Luv1UrBxJhW?Lw4(|~8U2V>{ZXDz`8#=b#+ zP;j3#8utf83OC9q8a}jLyB;8JSN$D!Z%Iy~A}k@rqLZS*-A442Z@`)(l7tkFPCD%R zGls)hIn$skOnJ{8e#8^P`X~rqDwTd0HAs-K%EYNRemH<>I6G?e5CusBhBrYyiUa&` z=`xh2O>4WmR@)9EeRx{YQnD}+Ooljrlatp{m#iRpbsW1r>=tyeyS3k}vT&JxvTD~E z)S+H;(6?!v(b&}no9rQ@GPbr%UdHQc^hr->yg?GPRvAMRWGo|s{jU-kWoH!!57n z{Mss3mRKf@Rc|v9eBbun-nLN7QcYTh9;;=n#tL8HK`+|NAJO>-`;NHk4Tn~llFeW4j1Moeb$AT*{0WHIEv(o;d{$$l?A ze^EFFzmR1B$C3Ft$;g}?FONM=`GHJxRW1vbHJ83(z}8gNLK_pt$ZTZ^L0H}?v{~q8 zVWqX^in; z)gcjj_gF7cWmDb3z&?Hns$`I(scDO;@|S?dP(Qsxi_os88SV4X4MSs$)0DQI?ZuNI z$M86~No>Mh)o$Q&ZBRZ}N8nSn(MouGrlOIVJd-Tm!4v`9CIw=DJtJg#u_|rhk4Dg% zxdI9bjkE-M&+DKbguCtOxMLL~QJRxk!Osn~p3k-N)^7ww?;psw}vrW(+M5RLzS z5<1RaRNx^pja^d+m1@uV(sPE+lM4o6k0f3^#~HtI=_hnnheO}l2n=s;+!|0y82(KI z!amG)k~cxmk9JJs*l+aET(y3B6RqLdYv8{*)^4el`&!w5V?90Ecc8hfTtyDe{9H$|v$_f^kcr z!E9dLFyk9|}a4E2WkdVSIIYXkI z16d(W#LJ4jg#RT#s3G#};|pF4Sb^{sRDX)hm>V1pcLCd?P*6c4W^!Ce+k`PPRXT`x z%S9f4;kAZQ1cVPmgedM`J|`krK1eUJ{E6z>q|3lS=0mAXOrlva-@=ShG2vny!B-I* zgu;(Z1T3-!E0|ARLou&`reES;)N@R(1Hl)sPMzbtHnAc|K^T^ZN+p!hEN3|e-8Vmy zWCI@oF){&=e`84ZNhytikYtzq05RCc+Q40ZCT7rAa5t$t`E>>(PEyJe_EkbM;tv8K zBu6&`#s|S?LHR>OzEI2Jj|R}Oolo?!Y4a@S#{C2so1d1({9hW4E~o9|o>8h`T8*Ig z0n++1J;eN-vWzgEEJl0`f%v@$#23G|pn^Vh?&jYlW9?6NL>%Cz(8p zhm;vH=$W$<06aX;r{ZD84#P{l*>KVmBz8Cg6b$WYNlBs#QBacM&iRD5Kf{bpY?v2i zV8cz^0t(n_+-^TL#LZw3lo3V z3$kBB-#@Q>ITz-Hn12Iv6`Klw0yWLW|G8lYcOjc|XeUl4x^pnSxczQM=N@&}_j)*V zt+~B6$iWo=wM%KHs(jP9pO50znmMcBgrpjO(0ah5Quh6t|uStk65Px5f>)*2*8gT3J#?hAaV|p zT{C6Q5zS5u84y7%`!7W)8?l$6v=I~nI5C&81_LJzI5P?_Ol59obZ8(lHJ4FK5h|D9 zOA-Ws6iE_&_gCcO?n`!FA}_JBkbqe;BQeqld$kwDLt~eqwZ`q~%K{P~zvrY~;C9pQ z!Y*Kh#!*#KnNg7uCr?DSm!ig*n1YdHyi{kDm)ZEp>w^E`9v&nUgXbNAX62n=vWpa= zDR>`3!OQUgLNzMFJ7Tmd1jT?pQ{rWed`~%lZfOz*&YmwQ#wm$2D;`w7CMqVlW{p-8 ze94$W)dYwpW(OhTt>hp@mnnHj$>Sm3jM{Dm6GS+nCP?@i+`||-Hwk*xdrEk!Ne&=o z6P>num?lJy0+kp`lY)uT=C2Ui{64~O(8UY5mlEtx0a8iIr_j|asTy&rn8K@(5G(b6 zoRL^L3VbXnw0E&2xs8lVEKJjb^Hn%UNCqE3Q$jYl&(Da?q*(cG^d?E*XT$)Bj!*D; zN*>Eta4W%Yc(oV^@Oy%5Qc(^pcv`g$rzUCp?(9v*^6_ajITpT)_07q13e25z=CqPc zuD(4jCTlZZswv(zNlghtDLGTFJ{PNhROls0!4wQb3Gq}NEl6UDO2Qln33z~WAT(3znGcRZCk9taUBg9^zh&^h(AcxQQv?k*a~l!$ImD zB`lZ*X)ZuW#}+nlrqb2WL$c&%Kw+FWqmVFKTTo$MReX44PGQk71$0#z;;A5iu$*HW zq)IV(iUqdeCKdRtuBBf>5_y;4{&*#21|`GB6MY) zFU;g$|Nal0WfguD7p!8Yi}m^WtAj_6?o^JoSceZAr0m68=EyMRkSv#QL;3F?R?m)C z(^YqPI5~OohsU4OsqvGikBxtSg#QjENAru7IXpCzBSe>A1=_ernMvUL3xsv(pWsU~ zvi14`fs7R81qb_MF+V--R_3Ld{PD|?nVfVVR_3!YCm%06Jea=e4kk}AZFjL+62RKG z986wx%lUe7+AXheuHE~+JDW|P%s-fyoSyR*4X-fKbb+^_h{$M)k1sBN<{0he6`<0d z2B_CUY{D%=+A9Z>EAr}(x2heu?3 z4r&>^(G}|vJ{hY8_=4W!=Fnp^c{V?p8?4x0mh0F2hxcdm3ma{*@>hCn6oatkSZ+I^ zW-EvU?L@h$7_wMTL={W$ z9w$+hXsFxiFge23kp1VZ;pVPiOQBtvcJF-BvYk(w?w?OpuhU3>T`%}v=rc@XFUXjw z7DKQV-on0t)FN4^mXrW+Z@mvYQ|&s>vJE2!G{UB0p};q60k?`SA+QAu!CA?&&lZGU zeTXsGA8#5Hk@934z#h`3kOD9X{K99eK7BpAkWuz|w?w=I=gWx3`%xAculONFV91sQUxPyYc*jtONc6ml-L{Y*!JrfJC1V zG2gsM4bL6|U7JA+q% zcEsOkGc5tJ6z_MN@@%nw{SHyyExc+P(K7%juv-}5P^1JlD6nhEeuI8pzizh3ZM;f- zqU^(~4aGix`ISW54^%D%6d~_X_Lal|bt=}J2`~~?+=Pb>;Mi3x-9nMwz_CFul_hw6 z7>WelMv+j4p-76dg(ALOV}`H2aLpHcm-yZttp#%}#9rt@DD)r{^24xaGo(EU5<5Cz zjv4FZ5!x)?uxnXV{<}l^$$Gh*Aw%yaX;kjJMs|uKpg`Ld$X|^5$K~bsFp88XvssSi5;7itIF7wdPvX44DB3DR*kK;Ft>08^K_b{! zie=|^k8&v13lJ(@6;XF<_uW;7KurUcL$YqHHqd=KKR34XTf6?)Js~#Yws!rf-?r=D zbf>ue>;Fx@-1y)P#}2HvhB)@#?#p4@ec9cgG)Yf?q^Cd9(;w+;FzJbv^u$VfVwHM- zVwHMgm3m^8`jJyVa_UD;{m7{wIn{Cd;_UQ#lT=#ME{14bVJ8829O}M~@0GY5aeIg! zH0z5!tqiStr#%~+=iAx&`9Hhao42bGIUv9<3VZZ02Ah@#0TX~zDhfh2(5Bhh>g||~ zP4*7MXOr4yQHGoJW=g6&y*Qq|c{d$@as5bo0`?1lmsJ!D0roJS*bL5LN5i!{{o9wA z8qpR|46mj2S4%`?j8Z)UjgZ`ksrW-};Yo_aCMOEcT)CS&+m59j)@ujv`EGuJ4L*Xl z7i^_4MM`V&2oHJ0?@Rfs)2E|F_viQ)A!w?6F$ghJ)&JOa^57R@gq$519@))*06i6i zOji9VArs*o9@zIGBMcc=f2b`C(^k`feifdlpfV4c?KmJ|x%0I0{X>E8R{ssGMO%L! zRTkS`IkkE(cn3>WF5Q z@M9{_+wEjb4MvBZGnCvQSjqT*u-j|B=MLIPZT16;nwyIKaS0GG#eup!H7R+IG7r#d zMT!hi&bpGBvy~J&vUi|%edg>W>?m2kw?_7If zB<}1L+0P#U2C@9rQD}h8--czxpzLiqr7^dy+6rz0P$}F(gLPiHx`=)gEkZq%gDXE zm9D`jRi1qKfyzWRDf_2yCr7uD>bsw(>}(BeG*iX^mimVfA3#u_=4Ll-nrZLFqDY7YK>$Ah z^oyIf-}2R=eHN?^t6=r@@O*Xi?8S8`Ry<%yknq*beieyT6eKKA@RqNBSZ8%vnyf1} zLa%?>aJ@F0f2{~5w4ozyigZ_+&5t+#d~qGk=7|N6-Le5r(ma-hiSYNGMui|(E}@}ljUVuyk~BXiHOJ6Z4RhQ?``^mr-_b#%A3 z5!o*{e;jzqCLPnMh<<0fJ7e5SdjeH#>NcxSMMhm^x-(@Ww~rsNe-jKiSn*YZR*a3eUq6E(q1_l6H}w3- z>=Zm?323yPN7FPn_836jzI}5|jkK(*gHP8Z&IDJFSh9jfZ^>58V8)$W!n9p+OglIi z``VvG;B)~gi?pTIsqSFsg;jfGs>&CnUFw`eNAG#DR2t~~I3c|poX6BOHPa|FA;B96 zf7;nsenSsOKlCAgAs+P?>e63C@m$V9JjnTPo2^m`XoJAF0RhJbr|pQpAC7HwkRjOn z%s*beI$B@iVNY^Up+D9&&bO*rq~eh%@UE4xWYoK#JX^fPfLA_QX%>TqPpEEuS{}nm z4}6!k*I2k_T&q6-mgG}q|C`iozELg`f0#&5m0Bb{@d~sqVX@G2+pv}@L$R)RT?&4^ zsEq5_-P6-l5GxeDj{%#RuE-;%qv5>onxZq;jWJi?j1TwMMIU1<_zaMNXab<2((CVv zV^JcqG^JY^;m~sMv-OA1xb+C&7^q<#1AMC1B3e2Jz%!YEAHoUv`dBxHrb@Hyf83-9 zV6LNgazu#eY*)TDBr}2L2uHENB!gZpT7XU@oDYQo>q8@wDv8wg-qSNh&2b@9dO+D) zVmz>PPXLEh6?L1R&w$*!rjH_E2zWLQet_V3F1vz|+Kp{{rd9Pk6A zfp~)?^$Fiv8q7g7fvDWq9Ze%JQpNtmxfdkO-Oy;)uV$*&93djuBDh&wfKl|X`F)ih zi>xKG^wh^+6Oiu32;o+m-M*YFC67U!IE!MpKZwremcmRP`J}MBvk=DWi^{5JFhtV)erE zJ9f^F-2-+!iWygfUoPB|e>3@j)rElQ(Og6RQCFRL-@WvimWr6vLuhiz!(x6%KAZll zEHkGrb%Cw*H5e(LP5aUt2ZCJ=c)Y9Y(tz*rtwn^hrCytT3jSxYj(1~`U@91pxZdx* zYdEUKB5l?b*2ujZz*tuf=kN`9aTUabTqb{x0apwbj%gP5gBy_Pe}UTRkRxMWY&{=# zTX&#>dQ(li!ij zvAGIwA!v;xhFVNOxcu3$ku#~n71%gL9$}AK8Cdt4ovaz!&s{n zoST|Ch(9sXf7-Y`tIPAz*+)l(q;6_0Psia8Lu9C@N%xHfLlMWr31J%!6&d)Y$c-B% z1INbHz=?EHQG|}milQgc6&NH6{{K||#mZ?CW68E|s8$BTC@Ok>FmqJ`GS_&C=YWnl zaMQbI2^bOSMSZtSJ4zFk*VRJr@!WRQvZ<)DxiCIJe^)JO=_-4G82fXTjbBcbAg7+9 zn$0j*TQyT#Wz8H?NNP_KNWTn_NV15jr5GqV+{z#tL=jvhSyMhA1f8NCu*&sR$YELh zilNBEP^3N=6eYB(gqT4>p3ox^xH7baPl`maFHmJE0Exoilc`-{N#eWCoZ8`nf3fJ_=i|;e9Kk5W;>o-~f?ciU?GwO`h(T7tW3VF=7I68ON%2l~TP&^y(NHQf zSt9lysscliEUmiozRz6u ze|T1VgJ-+0Ts}+pP%gEkuP3MD*~W6Kn19B)7prnghmF#tIkhNVLhWihl3QUMb=py$ z<&rdk0BbeRWlY#*>&QxsG_!pxyu5VyYiDwcO_bcu3vO!b+mI`RS`Eldi)zA?^*2>t z@GM-7G6Oe<*?5$Il2TVcbZ*W5?24y$e|a1mP0m(0-Fyr0id`U+gXuq_=iP0AHaw}g zN_Rbot?_zrvK{9{4o#Y$!8+0K6TNQ1ZnIl!obcu@9kIVlF(uFGZC-)Fo=5ErasyBK z#O1UwfxUc(XMdaa)LHcd)=LwltuGLjp_22QKCiBj5Km?Eh4{+zbH;fq9;<0-}09uG(^dj>qeT)KPO76L=oXHpfZ9Ij~ zd)4|0uKQ-wJg5IA+})zH^l2O_T)5D<`JxFdI#7HG^9eE8LL4sdOUJ^uFDSgY1D9~Z z(d7xx=f#`hp|*xWoR3im&nG3lf63v>2gUQHZ!rig$D4Nl9u`5AVsgA;c&PLjGv(XE z!Xz*R9~P$^MfCMFzRu1K;+4B&l1aoMRGF)NL$`YnxJ|*uzT=vd=}@!`7W!w(ba)6x zqWEXXba)uDSgGHZ>WnqFH%0Y5Vb|wObzoIE*dygBL)1D?eXPRR#-cvwe=o-s?%5a& zs_Z|S?8mhm?!1L}&`cJ|;g>$vq5a%*y4)&*C51+eJqE4Hi&_zE%W1GO7F*Bm#}Z5OE_i|Am!pV9G}(t z)FOGn4qwSh3~Rf8H^5I_f8>i5TbE+l{Y;}k%S6&Mk%+OxWjk#_30n4+0~?h|8_d4$ z>GfCB)EMdp$_DXtb&)up650RR!ckAN$;4%oSa*|2Ul@hnQ`)4UO+61F(RRV&DAYtw zgzAadZ9c&JiyhAA`6OSI(~-cFOxo{L_kj)MIq&~^*qE07tbmH^e}+}G+?)duASbT_*{XzNAQH)F?a2VR0N2bu|CG6F}_$05V9EWtWl54if`5F)){b{}K}c zHkXjF0V;o;SWA!FHW0q=uMp6S46GSGL_KorBAcKEQncx!IV3&MHfaNnVvUyS1(?tJYtj-v|!QQJ}L^r zGZAI9AT$BWF8UCgzFVz%!Q!3XuNaNhQ1(cm@#lXPm$51b?dFZ=>$IQm8%JO-7_~pL zS|@_XcdMMneon2p6$Avc^ZOW-``L7+sXHfW^Wdib)~#RnkxJTW?WXl7vikGx=PL$w z(WpH{Zt(8SRrJB`$a6bCS`JphdUm~93krJgaS~jS&Rrp-Ac;(X-+G}}?LqgiOxM3P z^&fw#^h*}rTaRnjOc0qA-hXIAQh2vWaG)okG1qQ5d9rgXjaMmK$Y+$3qL@@_Jr9dA zQe@P!NML~NNh(suq|vosR_iQ}Pa&OILb60e^A(>4Fwd%G4-nMxZU>5LwHvhhRI07s zIR<+^xZvogyGoU%?!3jPrZc@e)fJPmzA%4!l&HKkQ(sC`l}6>kGA>BQv!#bWQp!tB zJO?ELOj&bIB=aWyXx+-=d($7?sOwd|Q?1=l#MO$$x>vi0T2*G-U3)43-Rw-IYeb^; z39LM|%|>lZY5E68*a0S5vq3)(y@xEU-m2QoZ?t;?f>tb#0Y%PhJRUkzAKXy6ML>U8 zdoxl}hzmOpr4At#Sg8~vDyo?wp#x8I!m@1S-jvPuFX#198}PTa{1o1;;3Q%BxPIG| zpH&;&D8bv4a2k6_>HR@c2FIrO(iZA$IAJ!A?Gnc@;Mz|!fH zYE`dGzpwEtT&N%ehKeP1rgB)KOS^_ron2`I*M?l*HoIZ#0ZG3K0VZ;i74mx!m$L=p ze3~2Mky`x&JEa8?1s|8{&0E+iw1tq6cPE9K6B^hckCdSH_z&^|FKc&7A!-vw!w=$?L2a&o5dWX>aG5kltbGLCpL1~hw7W^m!aBd zNY$256l@%DH~2S{E37E~bx|x!`7{!9Ve61~!F`6)Nw+u6fOqnP7Y2XjA`N)q-s~`G zAPXhz8T;5k&jYFI*@vMwmCrjDx{SBq<0Bh|98Foi*XD5SN0ljilJ9JpSeia^`2=WL zAm0Qy&SmOrQ+o9s4bj8MPW1shoZQ<_gDHRS^~oC~ZO#4-4^M&cs2GMsi(vq_5|MN~ zyd&Izp+wIMlAIHLK;wT)@p(d0Ii+ReZ&1v+DT{lJW#*UO5vOtiX6${5G|q*+;@}8} zs)pCZF+lpR)U;62Ckupm*WMo=yYZfT4D-&FzJ4{3X6sokp`?`dW%`sQQ0kh7`F^em?|@2=E@A zY-YiJ%JVGreTFbh9BWRCH1=x42s_Xfz!-^EQCBf6vIDG>BM;mQj0ZvmBrbT8pyFQm zTyN-o8F=gb;4(=cQ3JMJL^!nQ#XfZ>I-N~_w``=NBNvpx=Au>cAl5hGc~zo(zhGy65dufT3S&mG)x z9~a}NvKgx{BtqkCH67~HaV6u2&TOF(eQ=XygPPtuoI>YMB$TBK=g#|ZK@%sAO1~)( z<_!wIKWOfZb0@dJKyl1AWKi(dfhMDe0a7R zt={%ix6onzJiU#d4SWTBn05a3)Nbh3JNtUse!@_bLogBq+!9PqI6bPiYHG86uh2mO z{A9v@)fg>5m!Q(h)cx2*el5ADBzv-7d{hHsqDlx)pk2=jNPj+^WXq3EP{{uWU7*`J zmyyd369YCfFqdKQ5fcJ2GM7Ol11W#i8p)R2wg8$yWxw%0U(vU)U(^sma8+Iowrn{{ z>=#EFKObx#FeJL037c$j(RltowE*0P)@X6^UQPgk0;&qNSNHSVH{Z+Msk`xar=7q1 z=F#}}M#AXtmn z%gElfzC@%UPI1_{YDJE_DpWvF`T+zXLxGUNjF|K{2zhikQq0CDJc%2>yuEq;Do%FN z7nz^Q-R*Ig0%K9Mi_;7)O?J1%?k6u6p@{bf>HEI-<35f&Q&orFT&||w%hWT){t!gI zcQL %_9l^KSpk?O#VUfFqdWI7mr_MJxL}*IwUMR`=hbFmyGT?#0%lWJ<)+A-rpv%IJC%7XvO(ePxb%sQMM2O~%0C zg}!oln&WX3hlN@p>GHNDU$DtQ9D~mqIe2{pYBK4W8egDzwm&Fef+Hw@J6;EGp)@*} z44j7^I%C(@8URZx&j2ghj)mDv52?Cyuy+qUeyQ7H$n(+?(IdgTgC&vJvW`zz;^RCE z+$b}zZ+N^jJYHFgiBa$^9=O4?X)Wwo*F5WbT^B$Zf6e(4NN8r=Fy5zI4f}A#h745z zv1c@~yHa;-ySg7*vn85;G!(&ffJ8uanVR1vl;A^>m3g%0?NEXcfV40Rfiyg)r1Xx4 z5zz;^7)?6?Mu8rLu@8K2=uspHfg-{2+j2ezpaGHp?SP>{M&85WpZOV77$_p3Q`-zz zRGJ_G#e>)AFQ)E!uQ~Gg@@y_;*S8NC6rT|%{*r|sUjOhC&`7a=l;VMXGYCqAQTRWO z2$7!%ImUxfLdp{SH{wAAGF4#1pA-)^bm}ugLIzi-A082I_lfV#kds$KidI?0Cj<*f zKSU^>2o?&wU;KX)Dy~ge_9e>q9U78xX9bI&kkZwGI@6Zy5$Fmzkdx zNiZt<9~mNBC`%?1@HiIYt1UdSh?6yzr8FSH8f76ct_I$J>za822fPn``*tN8@YygaDI;0?7PwDvv8=zt$h@RvlelH)H$bw+ZK*==?RpBBM2rdqn z0tD_bg7y^!`3UqYZ;iI816C~knP;e77`DO~UZ(4f=KLcejU>=@mJw|jZng@#;1z=S zGkJz-oQ$@Adl|Z(u~Qxaqbsk7sMw}65s8Z4MJaf-WR;mg_SB*c#NNA7Zzc?pfTH6g z@&zeUnay-80Qr)wU!SO0Dw3{M?l2dxO-+RBVHx5CTjReZHkc{^(2# z%!MyyO}3u8jzTKg>!UtWw*nR*!)B0$FQit<$<&T;(0zk$Fiocelo!Jd=LsxthrA>g ziZ~m8-nY1YuY(H1blvzAG-?}wATffBZXRWy%2#NmD=$MuJ(OkA>c&M%nFKopw(Y0t zvs!X0Nx`Ye-=ihBBIgrYa!M(ID)8woxleeKr(1FgBA%bhsU?@#mfUwxwUm%}9PV}X zZ**>^{XH6T-z_!6&%iRP+^Pl@a9B6jyv0?2s6SPq_C!R|@g?TP*Vs{{deQf%?2QUI-xhGbHDX+V zr#d$UFY+mg>{iCEUB)-&#CUvXd)U4dc!AuWexD0WHoAq7a7agw?|q|(t}F3%@vd`! zSyh%5rW~A1Rq?|3bQ{&DcC`zLrG#V?IeKvI(#u_0J16}1)s%C}H*owV2 zJ*IWKdN!Ukb>Z%Dw`_U7CBz0EjN;(FSd>tYW@=TWP>vZTu9*wT6z1DlmX9sp1binm z9fQZ78Z)r*9)ZY5@*wWAxn4#I>E2L(!*_2n^yju2PG{c5w5c-KM^TX4vhv}&Zd+ZS z40jJ`!S%OUW``|SD?QZtnO{B5EXVPJAS_W!+v9;9%v2<$0Q5;9F`ErQaz~^tDlgMK;;=q!$!hoU^_1^jL)T^7xX}T4v@90Vg z1%^?Zymy|SV@zt*0B4Q$lX%Epi0{uU-PLf{JoarW4vYPHu>O0x#VXSlpVm3yZWH8Q*g~#f`v-P>-WxU>sIY@3rswX zC7`TVx4So)j&J&Z)+Ajy*6xit@y`ic9g&2Z_hUzdn^bYcKP1fG$fh1)Y>_|X4_56E zqfkT4!L$N^ZIQH&9YoY90!)&f+4_i!uI7OJoE5?4f79fmQ_>% zkN1s2eO$SJhN%c#n>Lz$UPQ$i#j4O>xkXb|f5IF+wZ8@9rh8jOLN>d629wKuxbyXs&*he2tIs^ z6Fc#yc9SSdB~|ers3As!S`IlTF_y-u{P#4_;8WDgc2t{#L=bE=8jbF+KVZ%-&VOLR zReM5%tAGaI^v{F4?g2a4KxTHvuNXky4ITcB$_N89uZ@ykq z7;!@TS;$nxSAPY5+~t1krPo%dQW@pH<{P6L{BE{hpuvUq zqnHe@bk*X=>qZ-0T`ibp)?vqSJ$TuHlX~UeK-e68t#}8 zlwP;k(=C~LPpmHU7ClR+o8oL8Qi9mPvj3Z_V0bzI=H%7I$-5I9M>JqIJ)%UyGI+4w zowz=dWg=iQAzZ{kqk_%JkB`tgQYoBSta*Gg$;2lB}gyilB-*+PnmN>4R2;$Elux{r9D?yx;2fT{;b^s)D^2uU4Is;Idgtk zb)v-Fn0r+Hyf1R2X6u1JSdeS}10OF{>s_Na_$>40$|kmLn{8fU>z04)%&Vn+`(u*P zw@`&-DFZ*nMA8@sTp+w!*e=W3VWG#-9_f1wroC5ZK;&_!QDtsApsDv3VcHiHgCMS{ zEi+t#1rb{CmUB77AxLIQQh&^9mpbE)^T$X`5G%_FPXGyERw_iFVo?n4$O0AcmN>dBEj{2XPv5!&SP~`3}u?x6yC zJc|oUIEiRaBI?a%aSksvo1|Sg+GX3~0-)fDUh&0Nx8wZu`F&`ruDg1~&QC}Lc3moS ztyI+kfk(+{@~@z3#(&m)&VdcZ&z$}OIF;b+8PZ=!*d88zT>9TCM$er79oL-hB)&mW z%Pp52lgq`-7n5jSPJNyxM9$9~|Hrxi^MBs_I$rqb5cdcmcpyh(!jgUq-fWhZ56wtM z_f?5o=EI1=e%;=sHSTAwt0g_2Xm}Yo$q6ce6F4Nv_<$tPZhw_=y~1+_=-TJ*Gy*MC z`zL-9eRO@{2Rp)r?LO3y>ZB={8BNLr?gFvmarnl9EKNga6Fe^+v*I+tNulT9!WJ5q zRJrG6TbBppd%cw~;4PI@wR^SJdFc+g@b!AD{HW$oRY;KRY*nFcdcW7jAuqkakTFgI zm9}c1H+eT1Qh&-8W@2-QM65!Dl+TQiJYj&(S&xt@Cnl7ckm~>M=X675S5>fq5Hbk z22;k~-*^og%yri}z%M=*ph85)@dJR$V8@du0V<3T(SHMg${h87BA{l>1FDFl9#BOr zJfPZ^LrvSL4!cXs#B96Xcrl~)Ue4d0+2-|DueaD#`FiWI6x^96V)5K+ugs#*G#YQu zB1BJkHYzWCj{|ROCA6CE>wx3%>hIqGnuX-y_Z9YfvqWe_)H1-0({9E75JxSIT z77zyk{_+jeq4YZRPTdFb&rO0^3Un|^dWffz01^HxAfBah4;dec@OY>F37{@BaB=i_ zO#exl*@cHLRAsac&hG5vueWJOfCdy_X2KbXlYi_1CM-G0vgB{WgyC3XDbQy*1oOKO z!2>3_8d10!ann(7N&W8+5^v8&X*n*p!%?-{w{F(}HVVtYKI=hy_&I2~=42#$QpHK_ zfb{-~let^HrxhF?rCk6+t7q`g_6#0cIX=L9z_74AONS`+=`hhYoc`gUkcGck?(A7S zqJPbpO<<;pXv~}84XG0}%KT8Rw{AD#&CzKgoN4gdLKv1_&~7yTx+EeO9-1g;fpl{~ z=p6l^ZLi#`vD6#@n}wN_Lw2vButOm&e8Oas-o`y3!wfgt@9d)c5xm4s8

$L3WrQ-wsr!w1LsEx}S2p2DDE0gGIv40o}@E502hHcLhRHN5^iXnSMjP7Yo-r!GW zw#U{u`~0Aqx<8i8*X1d%8u(jt8c`Qcw(xB`R@+{ zJBQlwtc2_s&cwrY0Owmcl}uQpOEw>H=8 zZ+&Ci)O}lBUrD|`_f=E-$IWcm>z`k_#=dQiH1%pDMZ$`-SZ#!2Iw{43@IGUKfz1ylL3lgjTTI*W}T6AAwgYc(JG7vmvJWM)k1LFRwa^yTipE|1l=TNdwz zN8-QTZq2DLuMfuU;14?U@^CiYizQ_jilrh(*Pp@a#trF|e2lK`qZMUcu zyrJZ9w%sMEqsMOZ4#BOO^ws3>Koi~?rlvK#kx5;)1}^1+w9I;)44kw zi5*eyb`^~&53c_m=hC?(j8jY}mNI2YKFr*l`;D{rL@FlqOv$HnzqrGM31F3%!A=ej z*y*@m+G`5G)yZV9il^(l+iH6Y3n}z^OS_=PHCbkntj~X)*`E)t&$=qE$EL3OruCiH zZ|T*C?v3}Gy?biPFh%gzNTipNprbGSbOZ!e9a+J2A!BX4hZC!9JiABB)Wm`qQO;)1$m&iF*z%UYI#O9bqLzx}=G&7$)t&SX9~ z&#)IDj&FaFitTotkz&JspOI#^w@numv!}zeolV_U9Tc{`5_)~_I?H+&U^l~NlUVV1 z11Fw|@LeSva zv}iBv(M1T1M)SJs9aGKvNcOn z&%J+Armr@F1Frv4wuEn6Pc6tAOxL$%Rrg(VdUJyWfWS>*2Uuz1q`tMNmgno+QD~m6 zudA}Np@klSKioDu-!AX{2>%|?*FUmAnNwVX^KSiP^79YYIQ=LK$|R_v-aq^#88A0& z;W=R|P@&!)&bwg|e~_7%ZB^1Hous|Dcy@ z+Nm@z!>}7HCDDR(NqgfnU@H&X^Pwc#s(1p4hjP#@b(|W)s>=F0Zl~*~`|jNCExmu* zlAD9|$@NdQd*q-34U2achI-dwp?f;wyXN4}qH`TbP>h2`BOvo=M$v-&(6Tj4`#ORw zdj3~#w@579spHmBZ(=v5YJJl$4)9Eyvbvg(yIJVWCCjxpeCg)=ryEF!GY*6+ zYcUCm+)JBzkyJxW{IDd3k})-ntyq7j6zgvmgGA0UU<4R=?on7+AC3@L7Lp;oOBCkL zEXMr$8(;1447y|qtpCoAJW|r5i6b0VzW{O;Qq~{}Y=WmA1mt3Lq+uD@pC9zz4Jwj& zkVI}Mkn`nP*shdIT0`C{5vK_(Wu&?|8_Kc4VpJXH%d(0>%uaw(Rq!M3Q$K$Nu^VF6 zsT;)~Dpi4(W>3>9D3wqmR%@&+1^7=8P9weE4T~R_mSHY{m1Ky<(FS70Vr?o>E2){t z)u36muvchQ79=p$B0A2QouviKIGjLGoJvO%SKL~tWA#Whb5NoUF}gwyA)@t3U>O>{ zD*?D0@E1!$d|9Bsy|P5jzR-UWoAF7oCEA)#(qd0|0F7Pn-643bfDm+i;CR@p-R_IG{=AU=BMMUKJ8RXM{yi4UKlejPksNpkl4D^oG{opT^n`Eb&M=*e=v& zI!fh3$g%4p(+$R5Z@hoC>>h@jxnXU>j@)x|`&kT2CtviEtOL$uDZD7&5Ek#pV zHd3JLAw!I77!bLHi*X?#&(cXj!U}c?2pUaI8lu(~=ja#|-Ie{)e1fMybM+ZO{E(O? zK)J~%Dsg}ijX7DC4XcH9HA^0@frP~nJ31V9SpK!&l*{U9cjSK-x5NZB8IWmVrE|{jFC z4H@sBOXMhHLXLm1xRI&4$h5#KbgpOiHRlUD{}^2mE|`6enZ`>`EE}4P3XyY;{X`Mv z4EtxsI*ksW#1rCE&5_crCWEY#;E*POM+aw+&Y9LfYFuC68t2yt_b`sEn3YlL^U-+h zenF8#`&@<#A6Cla$?|?F1mSb-o;eUi!-8PvJ16)%ynla!cq-29TqnGA;qU{v5*tm=^+WwvfS z8RaWp^Z7Q3tqRUg?)|dJY|L!}0ShHJnIQZ8{cL%KOS=}1BIitx&i#JTkBYo-e&jLk z<+7G?;rxHdk9vC{R*49(I83WOhBc1at@T1dF(V4X)3}c9o!aKQysi#a?@7Q8pg*ey zV^|=3vpTq@gkTPAv%)p-IGroFJYn7s)e%Yi;odtN=vKzFh;DhZ@grz#SCyVt+*K5Z zs6`2~-*t3I_R9TCwdW^uwqompRXNg?1sRT4TMB=L)08SOe+wsElk(uLy)Pu#5`%p3#4|E_#)C|PPji|iD^YOYhheNsP2wl7YDs6V=h%>gIqo{)_ zFF>V46t3LKbs+w89yk=12=$~VHl4e%SYdlZ=^1Ui6r}4Q)vZAY?ET;imcgm`t)2+w zkNJN*eXpFlJTc$I+cV7{g=hJ|eCMl-eF^*ny80M5lp{ABRC8>)K8Wsvj+&GI4y3@k z(s|_QtD_G+NwRizK3BLtz#Ytvcn9datvw|~JLut!-vT;3*H?-E=t6zxdWYBV-R^O} zZ;jbR1uk?RVECYHC;xI)`)^XES(L_8{@`0-RWVT&QAx1S zh5fNWXOUKllya(!7nVCpCWNCQMcC#$;O2tB4QDA@8z5bhL_ewsJsBpM6zRi~*Ek?$ zV*H#emg=4wBeIoDnGWB*KE0qUmTfhQ7C!q42f~UeBYmv&{8Z=2E|;EFVH1CaCzuYo zboyxJImv9zHZq-0NtG-S}0}L)Sz=>MlnDmotA)^O959mPZ2;y5!y&4l_x=Kn6KR;ek#r{3{ZdAwmu5 zfr;@jWE=93z)22fAHLlAYZc1sQa$jtS0jgMDt6P&P~QnvBe zjA_ze0_X0#P<3#BY;+j`Unk$x3Se+yiDI66rkKZLaMb?=Yfu!&myyd369P6gm%(QO z69Y3aIhS$T4lI9j@UF^3%SSnc@N zryC8PqO^)uEBhf&ByltvjSt;l_skcUZ+{ZOb^C?~*8vaydhhx5<(n_Qk7OV?Gu(*a zavvBT#N05h;VTb*-My1CJp1?M-=?|DgaKzs;9i>RVA+50_9-L2yL@x|Mu0dTh`<;o zV+E@!mZ&7i4sWm>T18|65iuT`ps~UJ&CgF+d$F^4zB9okld##v_Wph*!<{|doe93H zn;drv^P)fq5Ex3Fr$eS<5bDNfb@@JR+Aql@PgZAb*3jhiO8^a42?A75D#R=0U9^fM+9C8TfAF@~^FN&WiQ7nEQdg{JA z_T6`tZLUwB3L(%!%kc9-Xs+v{IEoS`68VBSO3;7K%Hb#i!LN*?P_jgXBaTGuK>Zo~ zP!uMN12&(9q`Ri*?Bx$X{rLT-;wTnOe@0IwJ?w`rID*<;&W*FP+_nOMITk}!gWaR`C!K0%6@3dIY-NHdd| zAWXpB$!8MmecfdCo4RVdwCet67{$rMFuL(;FXIl=dK~dfmX_9^sMCX9vq2m8g&-hF zu~@i2!=h+Jm<8T+rs5rNCpW7H)NZY>An7)`=L&&{kP0Vm};@jBRB_JA7>eszP? z$`2CK*%?4f?=H_0a1A&BPz(-N0sDVmoPw>|zCn~ox{C$4?B8SJLbT-!woTR8E`1UqOFECvkUE z(14IO2Twuc-4+bOaqlh*SZX)}tvz(H|B(KM{nmei4d(0N1^1flv0-ns`Asf|MTR2) zrqw=PCALl?b7hS7idIU%+=IPk!SbL1k~Q4$Q7Yk5jQHFccazg;neckUw$ z#>5N3qJgG=y>(47IO||G>T(Me@EXQ?&POaDu^czDA^1WAe@w#FoqD@1K4yG$70#xy z*d6LJMXSdY#ae15_`^%z+8mLDClNd2RWz9Fi9><07hRwG&)UoN{d|9BZ)k;kqx!7t zQ}m$idWeF^pOjjjdALgr(t7Dx4&JcId zTi|ZsZaI52OT2%eL>+=Zkoo8}lR9O9&O-V&{Ai+>0F|&bz>^ov=@d{@8R}>LXkw91 zwV#;HK^hW<=IPno4_GK57sO{A7QaSD=o7q2zxAR*E2g;kNbZFhl39g{KWXxXzSv&0 z_Lw5c^2u%qlzJ?v_?)-&F?LvDq<>FN&_0qo0Z5fuc{P7Io`w7H1g9vAtET7=Xa=f&)YrAd68) zh^IvQ61N<*VKxl?AorYDu5SnbsfE_EcQ*=3%a+mZtdXn0M6ImlM<^PF#J%Y@YC9g*I5e~^>886D5c=_7i#XWzl?1P_8tE_;ev^jZ?H&P#}HMk1m{D+^?rg$jx zLU!SOg{^RgA6Hl9Y5ZYfT5f$H)2aaLcA0ey&qWe|ye5H-sp%gJ%ov6IJ4vRWbygx~ z^OYMeWyB&m{$Q;m&A14?thEr9Xne)ThNzV~gDBw9Ns>H4A>0sWv6hpB2n@G$0U#BK#&VVS`!EpgHT^8iCD;hdkW6^?#CMW_xsVyyL^6hHh9ON8>km0`U4^k zb!jm=cr@gvDm@h0NB*(}xfsxFrCeodBF>PZ0ItfCY9vk(Y@(kbTKY(bZu)fI51!dg zT3ve)*G-!DRP}a42GJuYcS3*ntKRv~17hiA;XCh}QJ<6^ZE@%?e6=THMy;}&l1hKb zlU2C;Cq+{;)CXt5cUY*S7oSMQR97{6%==)W5h}`vgkZj{MPGG0exCyd7t@1HT+3-uO6Z6KQ1wDG}aSb@O5e=axn-T z!+!xB;#L`#k;@Jfm$8o$76LFim$BaxDSy>kS(Dth5q{UNm`6^P7A625pevOsTeeb4 z$}Y#=lpf?fa5$J*#xvxYhgO?kpFRMP9C4+U6_?8|J7D8#H2V0uv0vQ&_=DUW`)Bdy zxQRD^3%_6AKKtTjrZzGbMO?_u?O{_CLgjjs$AyR!pzJqqqP{+lr*f#{w@E1-%!ca-nU+S(N zmc)rl}!DqJYPgMANK2gj^N%J;*oSJ_4U)Ror%`^;QFAA*BU1nGB_ttSwZj4N}?X7cH8eDm?)TF*d zo1L7nNmx3@dn_Py7Ob)x_~QdoiQ#(E^rKSAuB7s+xs1cwf>|n(H2I)V7E%UXOr(r% zwMs0mS-MRgGk-cK^EVep%HknTtFRRs}nK(ROPaXenfzTz{>90k2^9FWauNYl}mO zR3MUcDVqBlPKhT=WAw3i+#>nHFY6sNW`bq{%t=sLL1VFtbXMTD0mp1^7`1@vi&SR3 z-Ou2F7NgLTHnD&+W1~B6mV_UlGUD6YXTLs^uw1;69xJ6L1AR1`>imr8I)z}8Y-B2O zX*QkR9G?C2DSw+UKv{lmV+ur^761Z_LuLO!A=!s}L||>VpYBegJt}gDprHBV!SWNB z0wXmG3oJwuhd8(zD#47C;1*!p9fP~+#sm6_5g`Pc?LzQh?kQCUf(@J2ZqtRNAaKH^ zXtUJ37Z~;44PUP5cajU82Iq8FcIURKtJSsL(8bbVYJc`Jkaf}l-Vz`N?9_j`CKR+* z={LKyeLXCLIH@~F=%ejcx!@%hOnhSjOx5H#R(H)13x>ORg*KP~-~c(F>3ZGNP0Uvl6QY)BnAWy|(-~dC}4DNJ585lCr z#dZ7sYKs7d-Lgwq0R(hwtBy0xg~_jSlNXPpmt4j=nk!bXS?jMVY|`w~*x>DOZ5+rGE%=Fp>#9@Q9ry00Mm-dUm@<70K1K z0eQjH6%h(!l=s3vcC}j}MTj#;oel1Ho{pgQjD& zd0(R`2G!0XL7voK#ieG&g^^kZSGJN^=mZkZ5S=eJxVaKJKN9GR@y1-X#W2=(mMCMk+IV`hwB*?`23VKtL+_a7fe$NK*Bu2#LG4Jy`(dPY!$s zEIwWBvwEmp0b-eO^5L+$ha2^2(KQoOhJW_zz^O625^Q-uuVWc`T7~IZ!)*llYrtM< zQ5bWTHQj=0yu`?9o9ba5*DIlop4WYFlcpWGfmNR8=o}N)H>5ER0XOIv4oC1AB&K*? z^e#BhBCpP83azsOBI4=9WUO}J?>!jAKnI3y)ORHE{yFRWRz_ask>pgK+WV0ZA%D;H za~8FT40^Z-gIz)3KrK(FP!OT5+Icm?-!Oz7PBAccG?=EHoawn*Nmo|Gm687N-AjjE zyY~FC6lUF`r~HO~%NYdb(&!Xms`6BY^R6i_v^9oFm5LP7H3r=+dLb<#sciU{;yUN` zEK;B$yn?fbZ$HN0E|4Z+ubZ&a8h@f(G6BpGS$TfB18>YtzCdUMe@GiZ{N&OyrMyg{ zU`^Z~+%mq#h{5s76HF{(x~>q;MF`C3!y!nnPMH~O#2YYdmPqg6hPYB7U4_6y7$D5* zAu8x6b|9RAF7o)H3lR)fCSoiPjs!4@7z=lIJZUCUo>rA^!=2x6Y*s2~HGg>xtTaw} zLx)9jb}M7^OHbzQiU&w_jN3iW+ym&YNWnGLA^GB+z4O}T*?ESAB4gKkB{LkwC&tqP zxO?RotjgZb{fS2Xp0VS&^iJl=A{UTz2DmO|2h2^e(+L!2A;wXPQtCc!5DtSoiKj$evi zQ_K?>!UIX6l$usBk1+Dy&MEQX~|1#nzR#WxIKK!2z$_~RJ7_sq58 z6)s#WxKh#pNGq7mRd-ZsUv-~f@_QKqpaY4OHle-I+@b*|05d`~#t$@|BzDmW2?5a2 z*W4GCOGnx*5evF^!3W}>)G z^!D}HHa$2R@^B_4VSllpw8CP783@1lrI|W;%6Dq~^-S!oWFJzySdYLEpJ_#DQL3u(fkt z{GddX7ULc*)iTA!3U;X!sN5PntZE??hZABCh`nD4K07+{Zyu2F<1MH-Q+@QL z^7G2gO{}w*1l9Nn(cYsv8(so z#{eLA008HVLw}1Xsv@t?%k2g*RRE=to3wKs9L85p^vIhU7+ai%dwtVO3e*Or8jSAPzJ$cS-f}?F*G8Z2P9WqRkOl7P6Ft?^4f(r zO8^V04lhr>0I8EP(^s(B=S&FLoWTu}xOhZ&=&K67+ke6RdSvcOn+4t<@l&^>8v-Wa zKqq|g6+*)Ya5T#2kGr>fMyT`Dq1^9lx8U02$f5NK4IK5$rDWlf{+NQ0Or!`10Y730 zhQC8ONG1?m0gHU@^N0VJiO;AA6|l7V+~*JC;}hOLG;lV(qdxNfVIVom{uH&IrfqH- ze(Knwd4Kh*VstloWL9&Nb&x1@JxP zZGxY(NdVB{53js43yX7`QgErF>G?^psJ`WwVk@bAMZo`y&}zO1sn$H*T6^<+1W$v5 z)&ko%IulvqZrkX^B=CO!14}&95V#VvcWPPu@At5+g4S1aoL6KV(9()%~Ym*RI6vY86b9_BReZT7>J-0U}U^VQUTetY%t>m=GJDRP;s&FyZJ=ORk=CY8C621csQ58H3QyuMMn z+zz8X4dVJHg8uD)btbnRj~B;NW2t}FjR)%4wi>9{?Wi3OylCu;cGz|Ou^8*FeF+d{ zG|vw8@!Yr>{yuc)reg5Cra$u}K)L?u_HV#OvSdT2N*I{{myUz6==XN~$NBgMS)dJR zw%l;zcibo~Vw2OpAEk^K{7OnniAZV>{YM$gAQ2+bIzU2yvA07AYGwd)>^FP_Vu|He z0dysB`Gezob$j*8m4dF^s7)Ge5-o+!^`<;txiOK$hlxd&sZDP;yQ_ab0I}Gw-SQ+g zB7*e{!z4yX6*H_$AR;r^#U=!5O^yd;G!T?MfgoTg%7mHsXOEEaU~8;1A!Yh|1hT#w z>FRiZtvKF)Bmh9Oek20=pomh+?H7ll-Pi4&j%{}x#aqx#m2FE)LuJD6K9Azos|L}6fC)nKzM+`f_b4vu_=*c8Kv*E+<$iopHG z&rpY4BzeA42X-xLbq^uDh^H%MixN*J==&lm%p9eA)zVo|tw2(Ph1=qc8=P@hSsJC7 z3OaW@09wb3oX){W*&R>kk*C>zI^$?NB|`4zz>ZySdDfx|K?u2L=>ABsUkpQ6)@+$z z*V`I1FAp5qkSmipDKZ)YoxAl;nYA|x(0TppJL#S7|JpM6|~CId=(f#5SZf*94Wx70)3YOK3_v1a|j@ug(kx}qtk z+!_bak$}S)YaH$yUPjzw4=;7Rf8Afl=)Gyk*%H9AI&;E;=T3_XQ0Dug9?&JB705uO zhq?(KU)zD>(I$mht*shoT1@5~Ee?`7g3cEpRd=BMKr7((of~JhQiyU;hul71zO+>E zN#HUJ(Z(Clz!G#%K^TG2298f?$~Br4ixvO2<=FN2*Gar}=%Q`Cdxsvxe=9Y(h5fI4 zNTNVG_u*oK5|NIU79ApEXVIaPI)URr!QHOWS zQ*Io#E|9gvBn(w}SePKQ()8HlJGv~5{R1YCr@w{AlJ#a&{II!tLL!9#$<;q+E)JBOc z|8vvjNJMZI;F1X?)d%Ox%NYAF%$Fy$D^D`%26!}kQ`wVkD>9G4e}YXYzYb)~;87tO z&flFe8;q&6{?jw&_`?%spBno*lkfV{lfP*YVi%*Gu3f=GRzf~KtKMM}bU|WJ9BCxX zT-<#O2d{cw>Yj-_Hy-jEi#dgky^n*A^R}!{FIfTB!G9v8nIIIw2w9}rq#@4tQqltF zHY3`d+tNn?DF>^Lf0B+`c7gX7^s$;^cg`6RaKW4u7vRZ1B$3FX^r3atn3BQ$0Ed+t zO@&Sz^JqAW!hhOhz0V5{ScJN5HK`Wh|X3NTY#0hJ-Nkh!B}n^%1lk`#33a#Isvk`6|T zJXs0z0WJ{c&Ae)UuUT_xmSNaq%$XH)DrBXRxpc`K#4bUEjz9H2j871!0gcjYjIjzS z7P6?9#sM<9f42wQ+Yos=2ABUldB`x*3+i5muz_WZ^WUY>m(Dqh%~GS8O$aU@sT9a4 zdfpkR@SRP-wl7u{J(q$wxy<7N2XASj*;GdP zT)yNQhDtSD*>vTr=_yG??>31^EYw_*3JMv*5HksFe_3j!1Y#g8V1g}WmH4&myCe1# zXo(weULIQIN|X84LfYw^Jd92CM#{OcIP8J}*j=~5%Bz9{F!}SITU9i%>7ox$>ToJb zTX6w4O(2@M@Lp8#a+L}h&DAd4>&S$`g@;g$i(cjgOH1zijqC8kkXZg#H z)Nz@3e~8-zL!9XZ8dpYm<6(rfGZ8vjl)0S7@autpe8&!}DABljy#Yx;^qHq|z>jNR zHq=uni`_+xpp~o657fo#BkDb7S1qkwhCVbh1$_kGFT{Y%b>IxfzP>}fgItdxPh?Qm zxPydnpaD;)ul-VZz?28lzvZi`_Qe*kp371=e~e$0!Zk%Sw2~uLP1Ry(=t9usoD;mH z>K9o6ja8fB+*57LaQ;ouERn#qZD`w$NdjiDfK!i5RUOP|Io&YtsgP;TPt3ew^@KcC zC}HKg_BK@^Y0HVyaacwHy1BP|BHgrdyt^uQict;+t|KdDc#R+)fc*?^~;@+4QxywH?563Va z4dMsn;ji#lfvI-?AxXGYkZ7h)&%(jd-}wa5XV>&PKqX!e+Rr(rw}_$Xusqq>S5(E)VAfbo2|6+XNN=n zp#q0(Q66a2`CM=F3w9YUG~74+!$L_fu5H=DGm*dxcoJc|FJqG2Y5HpyhGAc2tD{28_?i)ST#uBmz$O)PzY zp~@hcm(kPh)SEfZTUaV0>E_h&JM*&2T(18sdt#x`NKoeY{aTZ0kzQWu-)FKO{hv+6 zkasJvT~Y3S`*S-pv)Tii^j}SSvYwZb%MKF)HaC~i5CanfGC4Ju0p}J}=uiYDefcf=g%FMXw${)MUL8@tuBU4Yv41$P-Qujh!VgAwS?x29oq#sgdW`uf?g z&q%g>C05`j!qHl)e^qvPX6IOv1S=J>Sg2KPR=a2ac(BFj`@k-b!WiU--5x4ZjEm6k zHQ$8AiiY%9+G$7F}%w=Y0LDIvh`JUfw#*Ia?&vlkZmb+o?~cf9{d()AF|e##*{*+B(f) z0ArocO;NEVh9d@G4{Y|%6@=0qOoO`L$-ZVVD(m|}7_7-c9_>L+)KA8q+5e4Z+LKTj0cS;O|a{AFVwvIaeGqY~k0R%B>-AD9sip z2zOTQNy|Hzf8(45B6cnpx(|<4)8svDwp9m!SygXmdMQo2q@bgzA(TVsoHzHg&t@9y zWc+fXt`(6b1vv76{F`8pf_+#S!CS z(%bywho6sEf=ec$yD;K#=*aQ+cLFYR??t&COk(gJe-*Nz$JgrA!dVdJPKQ&Gwr2Z= z6kr8(F>QeGctTiUSGfcBOEwlVrBt`#O`W%-Q=WL`Vvr65xrvc&;LSR(;KTZnG2m_F zaCX;f*xeeeh!u-?FpUwfs=~#RE-Yh+w@R}h?6=&f^`R>BY;kA5bi&N1FsulXZTgWExFN*2f--4SvVcTC`zVC_{wAP!j@VA)Oz3qPA_c4 ze;usf>}`^+JKVwQG4u3JYN4l(&y-zn-HekijZ*(f~a-152DUs5Y43CB0c|;qf{zv*NVv*5sv|b%~0dXr03Av;fa44%gSt`UrD7 z>%$jmQB*|6o&SxLN>8wTr7Q{{2$eaUf6LK`WQwNVL)Te5R_(+_CA1IZ1~2)+BR^)o z|MoQv0uTDi$`6mGHOSAm?zeBha+6tFWP?KR0~yU7>1`=D3J`~)_;N%Dm>e9}sv0Ly z{Xj-S>XX7Ibkh5YrP|k0MDbuOR>6>q%^GJ4uG$J#d||B-L;`53XNk39VQ_J&e*v&% z$WU)0KfUVLY>@F|NmF1^ES>%h&Uq(aDpHBOvpT)=02&ZEU72Mw7Jy*Cs6xh-*)1PI5E`;J47 z*ltn_>)y?^10{qASKD<{3#TRmIeVYi71dq0+FH-T*(yPJ>(dZq1uv>@fB$mn09d+E zJ*}tX@v#F!4pftqbcB}o=?G~j=2R#&`PMi#JFf5cdA4^$9}<GQ6-Q18aYnEv4=nGj4W&(hs^mVbd`)PEMDz;_4OgMAl;iq5tYKz}+22&v9&aONl z152!X6ssQruMS4X=k+@goO=4@qE9lc3Lt6E(Ay>HMocO}sW%d&e@-28(CTokMs$Vs z(Rww}EULF*6%bgB?1L}u6fuzmGxMOz8w*g=*&H;HWawBIjy><8P*JHUb%{`A!i1Jn zsX|&KscH>1tBF+adg2G#Q0@yV4_VCP2?sNyMUapo*=`g^yER#H08O3$Yki6XytsEdfb~{Whv~G)y}R5*Ze`M!y=WQ0MsOVlKRRE<8OL zxa)siw9gp^9!QWRC9Re>aLYtSk7Ej=FPBe(DR_p#=f{+!f0M%Rk10WS8#OVRGr01o zV1X-K29My1NRo+UKMhv|aNnI`@ugmNeh`tbbE};;VX;3y=PMxSF$;9I})+30aAHiIlnxMWK zEp>_LxW_w?e{JX84Jqck99Q@o1XqUHFKg56t76-rhM+VSRT*ZECTnxsM6qp(;(jr| zlqkvKB%0I*=L>|8MWWZjjmgqeV>&V&mDF3Q{bi;5rMvcZxv~PJkoAumUR|AoY&h;& zYusz@pOZ8_Ox9It>p1+`o~q880FowY-^NaIoK?GhyHLX+I+Lk zQC>88Ri=e&-Yqnlg#&ODEQ}`}y}m=evDjROkEx_Dsa!u+BpppOs?D)TGvnW^#nRv{ zv0yu2fBl6_vsl_A6OXx^RE2NO*Ml_jOP?>^9e_9SV6zYPq!Y>XaOeK`rq<=oQ3#QX zC>T|&i!5u4ar6B?M5MiEOt_qt`a|2?S;cToxNvMl5k8tWi9BW`gYqrdJd(3Ume|qff=es_`oyD~2v)rMKhG;PInOV`@ zU!qcjW!zn%i*eiMZD#kVn}jYK)&J=-Rgk%ezD0>_Tf%#Rx|+vNdY4LF1ul}0yGt$8 zgL(Oz?@k{WUc`IDqmG)lAZz8hZ*05&FD&=k9$dPCBN>iq{9r>;D*L~aQP?9h>aC;y ze_v7xc)f2rFg}=eUu~N%K91}LI0$Sbs0C;7XSN#{t$?9;v%#c*GyM)%@QG$Y@R3&I zZ>&Dma6&-Iu<4T-j+&AA;byiSKAr8rOqd|R$FrC3XEUBCVmcY_5vXnowFMpVw4l?q z>OStj8(){EzP{)zmB%-b-PA7*J629v6s77}WN^uZl+B{POYNAKp5*Jlmq7 zrzJr=3|nh`bxj4noa!$a(^b(F<$ubxlruY#a~DkDEOm(Bz|J7CbE^qQfp#+%bRGbb=eOq@TDa{bc=n+{d zGoEIz#Y!+MA)-rd1Ypfi!b*%F2I$-iNsIDcSHIj5hbDnhJ>CJ>+uoCYo`ybY1lt|{k;!Ir)z3<>V{ z-;d?0(chZ4ox8d>IP6oAwu4T}#h-aKIW z?0#NM=FYU-wM@#DV=zk~&|c}fsq$jgxaSsn{Uw>u+ErEVfn^vo-g><#tp82#(wGN^ zOW4SUT#RdlGfC&x1b>K0Z>SOPK#t)w+xAXB2uP-ZLD7KNfGBw?0Lm1cBF@ZffFr~~ z1f8DOgy1N}>3+PnS+D<+yk_lsA*V6MpXRg{izlNr@popl4D(S&qk zAID?wlt{2CU4O;%bK(a>YX%T4m3TAk9U$d-+J7`X!a|9ZyVE1Xu#-u;Z+@J6I0iLw za^=6a8p1dsB!n(4K9v2l^2Y4Zox3%e@BgwK%n{*XfxpeQp%=z3 zZ_CCc7)F7En%cEl9RPpZz}K!rUTN3vNy;WLxHXhqzezH#q8Q;Ouwec4>Mh9i)=}qC(R`bkgvlN*AAFp zqN{5r<>mMO*?rN>$D%}}LL?)*!W8qWxeO`UEM8`QkHN(C8qj3iXuT+De^bJpbrE!% zIusVuwtpM&u&!3%paf4(!rjH+~OVVd%mN?T^5wWwI~?Re?IZ z!V(P8fvZAxd-KdR%R#HiY>zZ+FMDa00PZ;9mwz`-Es6kFxa@%e?kc@5E2r1tu8378 z5c{TCZ+zFhc7GuSGtbu~R=xxhLonly@zjB7XDFrIU{|#}8V29gu`QyrWiroKciOp| znZsKnDtoMGalx~&R<7Jyfj``Gp`o6@rqpj-N4pWA(aiu2ce-5arn2e;ZkIY=xhp4> zhJWD#^HJK#qEMFZ+PMmnXO~{hvd8v?QOxvZ<5DE4d`yCKj*+1Bm5vn{;Yi|6gNqC) z5D+JjQj91|jE5a797~5204F1?3wFLJ@5+ro+;+9uF!bP?p5}Q(-90j&p(R9Ym|x@j z3Wd7Ed>d%PY*^_OUstH&h|)dva+6ngx_|j_%yNqu8pu>sZxJO2^_FRQe!WEy&C(q< z@5BMY;Pg!N%dU{DtQ|YcE@nUYwjeq;hEmuvyu%R4Fa>}<1&Y!PGWGFLbZFfL%++Pa zr^~J%T{4V|tJ!uP)*V2$q+`$3jrgvnEfdY#4{qU{Y^)xmP#VhYiQ`I^!D{VU*?$@8 zG4aaf*b53I+MS@?ICpdMh}z^hE>fVQl|HUYfu|a(2wMtq^QA-ki^@IpMVD!rxfU;P zNLOszyC9QrRKb`RyW>hfi_uWUQln5CndL+-_ys7ArCv*!i%DMVwkdB$OH**9P&-rI zR_IbB1$#<8LAB7S=;x`YXxw>zMSpR?L$syEcO53tq)tS{irtrPI(%6Xf0zG|F1Tx*MeQ#C;--3f+$Z3VTk?Qi#)HA^?~kljg! zSr?9&sr}5@Kh=O+d#W+Ug&^M~-`WwQ$$%n~2HGsE@$wq_(DAQkTjTNmH<0#7MPcs( zW3?~Dh>0c20H zjeX(o3+K=OJoLIhCIl5odq*0ls&!R{_`c^Ey&~oPH&6xo?^WuyHlL-`eVyMn1M{&n zd|;FmHvB=A?)$HsVk~hK@)>+zJpRY&p}{-h11eW3wI>0Y|7hSmHB1EY^rsx!*puo~N%kl>nv1R(}d6;ZhTs1Qo4n65cJ+M#i546L1d(1$#F^g_(-oOO7S!2vUZ* zp^b;9IbzBTgILYt9E#(@+3sPKnr#jeC&Xq8MJJrw8_7uw?P+$BqRm0-B-emBn4A=` zIq;ek#U&Olm26|zLQt^%p8jMYV!Cc&Fx&dV?-ihtT@l3Ywgm_f|>Vo#wQ zRm~E?yA{Sl!gw`B8y-S!YS@zy;jJ74q-w)Oa*5hxks+x`5?x}-m;!4`u`OHh)OH<` zIP8i^*l65p<3*Q)?Tz^oE^6atm${gfg2U)G8`g*W?H)VaXUvfV5{AO+Ar$jsRF`cY zJj5WS?G%=hD}UKCQgIqmld3~lV12=awv8!4YAeg)R3btuXM|vEfrP2mb{Z1&G&Q{p z3BeiRHZ5Wc!hG6=dAtk#9yDCSES%17$qqL{V)zo&ou&YXDNfB2| zGLIF!7S?-V(HvTSW!t&HEnN!!APU-B7%sGY%$ABlrHrnwM&lRmEi#yp;;-EJ&wu$V z>=hp^z=geFcjk8=KfW71dD66h|7rEZ>(yj6y}BB|dG(U;&&|Zq`1w;uPw?Mpe7%^j z+|`vEUw^~136anSzJ_z7ZZEP0-R43IqKLZ-1P#(`eL)sq-8=BQW%}jpRly79{w*KYh~`f261t9kRwzovLF`Dr>DKZo7Z`Rdj{q0KoO zznb1I?v^*x+cn&@dp}M;%qGtkpWIthGQ$xw?|(4SWQn(-h=gj2Pv`RmMti#kO0%Z{ zT{a`byYU~!e;hx@ z1!j9^>$-tQH2RDTKmvG1a1`|kA%}SMS~9erwq1Pf#y>3HEF9wGH#f7@)c-hH&gRpP zAAe^YDE-!)Jcu9w0umS1ZAVyj2i*h-19CXHvip0ku&3ycM@Z*=LxC z3J9}KI;IR~Nvy%AR*y6GB*BvCg{>+VuYa8GHRbm1z5S2(%^s}8$Ked(q@IvOjGPKa zK{WV)V8-rwP5F|(5lJ3Z$}zDwmL}0mVDO{lV~!_H88BeL@O%IUcBY^ndBAC3OZJ@7 zs#UF@s}%}{!s`X~Wv@^jC^8b4P)WgGJb1wgZB&~Sv6;-L6{BF6QNhnIl)JTYzkkjh zFNeETbFZH6m0fTFrF>X5&#sMhSR0K*_o|H>gZFA1m0 z>5W1~0kB77kbnS*m(0yX!CTV-qU@29pbYCuoM4e&9<>A|w}L@)MSfbhq6&aV>tjHF zBtgHcLCI^_}6n!h`Vd3O5o zJ?Tg1r=Rt@>tv(Y30)pimxrW7(oQt0UV)%S^a|!k0fotkABdjNSLn>M$@0V9%?;R0 zCNSXV26FXejNoL3Y4U79s{IBSes1!Nkl;Wpb*PTM#J?aXrAnCsaBG#C_E z4nTo=@`yb}Ojp~%1L6j4Q!nLQL6HGqy_7}8r_|F7fz4J!|4*9qy;gh(y20fT?>K)O z-tD@Ob=W$v5Ab_5Y|odwUVq;4<=K9beCU_%O*Pw3cH+~jOZ)!X@9KV^8Z)N(@ER@cs#(OQKs;o#6X*4$tR{q zxe~SWN^GkR#j5s@>7gfvJLiJOj}OmI$5;>3G3o=-k-K#4_*vWv9Z`!NQHy!Vlx373 zLI`PKLr!62FFqL#1`G5dHyAg#c& zs6J#;UZ;w_^<|<#DzrfDpol?FLZ+uI7u{lF-(p$^a$A zM?(wPz{cwZ_vPf#o6rHo$I=tx_Y~2sR?uVs%1OnDqF72kp}467%&4G2dMd*i9P1+j z@v*NpXCrLVLxfG~e1uJLP@V%q(Y`t&8wt38)(0HkHo}^e(|-pR6b`~K<(}cUtJrk~ z2o^iz>Zgogv9I>u<1Az^BzBAL;Dk8G!}!SDGd^-Th>zS6;!J~{e#Fqe<$$Gtj#d{F z0tR4#-p*_O%4e<@)A>(`sybjpt$-iD_Z0{Yw?}hVGAl#v+X9v38(-CVvKhU)cbfr${$fwGn z2k@xK0iYyOfsN$svyj3>0jHAC<5V{d-whJw#^<_*kOX+mmt~e4zTF6B-O_Ce6}KOU z&RL7xaXD*|>8uu6wI>?vDsB@TPT|~BS=8H)nR+Qp1%Ef?)Kj^zPkKU^D(GWP4L|K? zIN#wYZVyDxI+r`r{hp0Nl@C#)W=%o38IsTH#IGrvNPe-1XTpj?yE+gngU%-1J!iPZzcXsEvw`MDg~6M=9j(=XJ3Z zUrV3;`G4EbljT1b^V!XCMghdV{T5TeQS4)y{pz74`?*Z?M?NTZM*RBs1yTuFcDtI) zR|EPfnkfW?LIvjHVzjSJYvM2Eaon_tXZyrkO5FxDp*jS;!2NY z5@%nl(PK{lxd^_3vWQB<=WkrAV3odJo&N^}u>vAPmyyd369YFeFqgr?5EGWH0V{vS zSxb}Swh_M1ui%lYvS2((V5@v^oJ}f;E0yd{*$1x=90`(GrbvaPRx_2#e^2AV2RN8n z&FsXvh#&|w8r|R5-GIKm{qPTx?7JJB>=T^)`O)(aw>RJZDWeI&NMS{i+g+k?l4FH1 zhqrC=OZtgYvHJD)uhU$lM1qk_Y@>hOCt=5jYeu}kz4_M-0dY7XiBgE>3|3`GGMQ|S zH@2T=NJ*6tfpQ{~Rwuige_peAu(f=?HG(Oku-jmNe_K(J>W9mU;IwJCW~(qSO9%mh zf|_|;AeMtrJH9X4z3%^hK7QI(%b|S#Kb7Q(|Wb00;gO331fd+mwnmP zuBX}ArJU7Z3D@{wMP_r6IYXF=C-eG1^ z5{OFHjATd%m8@w7>;K;9$?_aYl27O%2ou;G=mI*uC3-Sx?E5i6(ella!{f?63!EGXrO1D4frAAiH2;4AM-Y_5=K(m9A}PfG1ULdBno_SrPIK;0 z=l=W6=6pO?MX$F%H|=j<9ekKXSY`o)7*z`hnV#z*Bv1ytdrs?Tkwl0@ggp_1j3%vK z8vy_ti4jpWSrZ0v$M4{2lsRv&DMf;a-wR_ly7Mf_OcrBg1exLxtlobXV;nKYlZ-+i zJYR&dk+^pcr=siL-}k!S>g|ukzAfr~S=29vSuO+RxI}`oVU>edB=EaHe9AoEpH9`o zYE2YQ@5-Wct-f*3V$+|C%C$F5_1SE)XuEG9(qQVhP}X}lK(B~M{eFfiV2ZK^Fm_Il zP*)%-cx+Il^r{B7Uh{t}LpgWA770lD{6mL1eE&$MR#SKB2aB| z#jZpCli`yih?9eiUDJ9k`-5)1k^o`Ln*6s;=G7XXLb*)=NK-0T{ z?Zq4j`5aL(s(^o1Yr%4Gwv8t}#ynGKzj^Y1i16kdR96b`M-)a;X~z zmL5h=B$5!hs9iD0k84pP;L(6XNwN7 zQ?Sj+N{pn1c~Hp3m=*o{uIc;c=)Rm9AWUC6i$N$QAw4oAr|QBw0K^n->h4@`e0>3( z#wMoMIRZM2L5wj>=Vuduq9}v(r5Kr`Ob8z?%tY^X5O*o7%5P>gmHXmXBw?zs0HCH8 zgfqoF5Kn*U17=|yaWTUrt+mx1zB}=F<~z_5fSLYf7ezTNDf0Z9uoR0%WHPt4fm6_= zjqNwFra?moZ zkxU?nqdZ?E)?>3RcMmSFI>ki{KmNoP4jYOd(+*;V&C%w?P{h7E>;xu3#PPezd6L4W`YnEmMb=Wp$p@gfTdKis{+_5-cQAbCV&b!u*R;XCj%Ez_~)X zV1rnmL7@Pr4kvygmbm(v_;SUyV?r0YjzS4XLS?Vg));_6lH-$58Q1a}al#xYasD!+ zMsFm8ASIbOt|Xl0AXUUd)mlKH`?sZ@FKd4S;?>1byD`Uy%Mja^8P6pgFUznpHmGVY zx}B{FjKTA9Uc2+@6bv(Vc~;yH9>-p4eDo+a91S~m!`HFB|7TgjhSYaQL3{O*(HQmV zTTwq?^_>3QlK+K!m_yv4MTGLNWjr-UaU{P+RLt zDBZpY;zyGQ$iCbjk8a>3A9b?Ck;^cO_Ji zP!-c$4i_Quqp?ESbo*YpsA@R`06BkIz+Ij2 zP#lHSM$BI;`5=?hm}&}9%9FLUcR+Lf!W%^i{!^2F7{_I)$%FT!^Kzte?C(ceZq8jO zV?Iq=IU&y(#0LzVQ($;(|4IGjSDb9&8$=t#Vdlk-JVI~<*O+Nl@)59ZF&&zUQEczv zfb>#%OI$|PC&kR!A%g+}5m%+ji69G1tK_?R`f4y2uliM~DzR$1F zk*e~*c=F+@J$P*=mEFs(cPfX(IdCXQVws{8k@8sC+W)@Y=;ll2JYr9L8A3p#(P(_= z7v|;7`+up$rn!=f%|b4I?7x4%xqA6StQSg(OlE3vvtA^6k;qI)3%^#2U!%M2zVXXz z?PRpx9}8}l4Skz(e|M!!`?cKO@QKVJTjsPW1w zGs30{1Pcp)WEwN3aYE{>qxjn#7bmQ99mO3}z@9{wNZO##NxZn$!YEBtpNVR!hg7II zS&XR4w(-^a)!drbN{b}PfTc7Lu)Xe8ppbeI8)e=bcD!8MuLe2gbyx`~~zE8mnyzY@#q#H7({?#-);cZr)J&6rpUWdLT% z2xl{5bM#Gn%*(oMUH}MU2ROyAj*1*FVXUHCPaP}&K}ucw75&`T-IvEf^zhvU#bN8s z&&1S5cV)Y!KA#udf}OX=@^-0ZbVB`6Z@yY}E3|w5e{Ox((dHEib=bGQZcF+Jv+C7A zi<_0xT^{mdzVod=HnZrIa3W8=^yW#Io~c&2=B}*EdUIjPj=loa3>J@iclo9UJgo+c zNe$GR;1!dJ>4;;veCc$z?>^^XR{g6v5p61r?9ulc*;~+N)0DSWST&%Wx{JKwF1#z) z!|Da5fAQp6DkrkI=USDu&yRDf8!!Y}4`I4_$d~+qiFW0#EIzWfEL@<_JKPcM^p!6F zI0cO%CVjPH`l98zhVVJ?Xb!$8k+`7Cpt1~%pd-b(9wlvARQ?5C9T@;^I{aay0LU#> z5CnYQG?zU!9_pEXb!;2Bqp@|-PxS@gfAzkq_6UW$AU$?@oKMHd(&RM2x`nnH z?k)|LEJc1eR3%)ZnR|dr0dRJfX?luaFkR9g;;KZQ7yg&Ib96u|dmr-&WzUag9w3DL zJJ)oD?pQ94n*}xA|9A!T;Gl#K!(AZ3ZV0!k(`e&sf6VD9N!suknM$R*XaWcDc2||J zf9MyQjqnZX1(QU(SH)k76Y(#APt)gUTp*LstHYOEdDJDuj0n=IM zl?ave@yW~C)r1^ecjfC%Fq>ci?&E2ZXE)*1M5kcXQ0MR$)Ia=yBY1an^*f)8!hp?6 zIL<6x6uYa?Co;IBDv=@qKXvqr_0_+hf53Ib(gY4JQNn4mI4(-_X-OSVsv78M{x3|6scn$Ao46m|{}A!YLClsX$%PcCN)+Xp-49PN{1 zhw2mB0w-nk-+)J&Fok0co{wn$m@^5(J%5Cc5Q0tT%;5jN9CG6kSX3uMf~N7&Y=a%a?wH_`@Y9=eVy2e@*zXU&8I_#6|VKzV^SL%Bs9QmZu%j+$|M4%a8P{ z-G;ysT3&1fP21+j-M$Vk8~TTklYalo8kcnasX?AXXP0i`H(+Vf1S0wnX5;*l`H*{lt{8F4@!(K={~0gaf{ZV-jdl@C6MHS)ujjXZjMDmR3d>f8QDnL4VoN z?0jA`hx7i#eJ9Kyu=TMfh0-sI1}|4FxN{Wtz^@^I;Vq6u>>06Sp}k+vT?8VvVKYi+ zk)U6cAz`bNz)mEv3AoEMb>I4q@)Y83?BbzQLjf2xr!b|y6{IRf>v_@uNm>9>nF2C` zZn&(O45lE>eepyf0x(}fe??3?6hz6|2y0joAGCHC4imhN6e+o%VByCd@1H_3ajg(y zYRHrgM8|Q`dxBI!eh#+XiA1KoCwP4AiEo%B0Sa6VBtHwIVM5AnG>cD9?(s20P$p5X2Sbe_IZBeIgR1WvE-A69)jk~X1qfAWFSj`ZA;AjKvl+kXW(d9-N1GjIMA!& z3_=|tUG}WN(U}9irC$de_R`;q9S1gQVESy>u@_=K?A<9GcsBR|Pz2~W#0y!bzc+kh zI3{QM2vlbPoFo_?fAzeEM?+ZaT>N$T*`M0OseK2&dvpF)5J8k|2XpcKAR5d1Ad(;* zQK^1LB&Dcn6ATfSfWI@6Oa@tQ@&%G&z?XVnBw4sA=IekoO$PofkibFT3#9FA4MbSm z1LHpsmHE{d?;PXGl^hrBCs{veIgZ^-iQ(bYAKXEbOse?Ae>3-uiWZs@jWnX1A1RVP#*KR6@?K!BpeC;cbXn4`^9t<&PmEQ9VpJ%65Kf@`@CyqtlISh1cy@mxIXK^UY*Y=?4i zXmqJ8ijRg4lQgZPn`H`Dm%2S(3 zUAbzv_nd@I2hXwQq?nRPXicl8*n{?gGD&)`F^RAjw`vO^#1oJ3_*k8 zg3}yqrW}|5Lf9}!cey0)Ive(Jk4M+3Fn_T>ci-;Ln?qjs>&D~zO@A$_vT3LH8#6aD zSKSi$BiMl_2Lg{eX(PuLsNo7%u!&fj!Z>}u*`K&Z7M`YU+P#N9A&*chg>$pB_`5$F ze@zDm@(~pqYH9<@gA74UAYxzG8&zB3R}U@p$uf&xSCC_zHrrv+$p31JGNum%ds2J7 z=X1$>|G;MHT<5#82>zF?89jam;v)lt>$S+p7vMPZWB1QJ%s;q`&Szg+Z4(+Lq6w*Ld#vj|+5k;@Jf12;1? zmmzKv6ah1rLC^vzmrv*t3V+}uJrg6il0@IUyGgrkx05EG?sSrUfJj(Emm(Ej*75%O z9$ZL@lC63zOG#hELtG9H4nCY4_4?-hI}$D13mh#Y9Q}Fk`Q6RM>$eGw2u2c165ZTJ z5=SYP2y=KVqL1+>O2y?bH-DYxA}Jz_vd9t5GMYEMf69nAHy58T2!F7{5s9QkG-a?V zLmA7We0|~CNs0&t(GrA(j2a!?Ui|YZi_f-}Zf_0PAqu;l?eA}wRK)uJ?vmiRZVJ0q zn3ur%z)(;-j|;?7VCu%-HKx-yKfe3v?Vr3_o-EO>rc;9W$hOt`@`?%^7y1*%v@)Hk zE8kMzx`n*DU;$6OcYh3%8AFCJ<@%NuRL53!_?7E&bxEDh5K8_pNFD z+gf+4x@ciInQ@PxS0W~*C6FZa%pgkA6iJ$lAmRjJauN_F8AF81qd@dQtv97^j|Gwh z*4fE{6ofqprW7ugBrgXhh6N}&bzl`omdzg>|G9QE$0T_VM-p18mRI{!t zlY2QD-FA&KRrer>z#?HHz7~jRg3^rbS)>!dhyg^h^cWcZqhEjM^yXW)NONKTphcRH zV$;}T=5QqD5toeEKWm8xB|I7RgGM~x(oIfBEDV){_A#iBY zg5c%DA(3GuFgpfBZ$9^?d=c|QaEcfcFK&RuV*($9PbQI+^0_96LO=_AzK-(}T%r_$ z+|hX@;9*W;goNNoGJ3T0QcL{;@F5WQrKg6^DDPqPaDODYcrJS2rVH`4k}*LcqbKPZ zk}*NS#y%4~rCKiv^&wyBqA&F~9{J3LJx}Cwe&BEkMh{PkS4L3=dDtm{gCUE@&rH4Q zzT5QOb)NU@zEqtqey*Eek2XFmMM*~I5R!BkLeTPb2yw(QJt+0z_=lt@WsgA#Bx&@O zWdN{AGk-)<9$gUzRx1=o9);QPoIwD>Y)&!a=@j^a0|ZPYU`zOT_&Y4N=Cd$dAS%bm zhbP766O?gF+Q&nz=Hd*jI7b;JPY?(;L^9wYCl1*og6vHeEJGNl&r!)9`X>}; z%#smj!a>cQ5_on9W--R`b)hz$v6tXC`x8vq-+xV|RpaUJjA~y)=&T#Fw!yP&{J}Jr zB#U(pkn$}bj6;|O>>+r8yl6z*KTbt;*UWc_JFNva0J|2n8NVf5Pyt+@ht9Ey7E*X>S;iBD_24TmbY4U zeWO8IhO_v(_5Jl`Q@1(@(baxvw^E&NY4ojbbd~E@Lyz_ygC3x5(1Y(-!FW#%3%9u{ zhZPq0gIId9ozpqvxpwYM0SfWsW_Vy8>VLu7y9Y>$uQ_{Yk3`U7*5{oz2{csQ@D@_4LOzVbbT8XVVA4Ki#VTF1>>8SZz4 zngnTsarFC|+eQs686j~FSl6S-U{h}_AKT;6>&5`!xx1C%rrc$-!6S5GrxH6v`G3cN z{$ak|8ckw#Yu9kCcPnGJY3G_C!ksD0FeNPAc^PoLHkDbc&pA&-t9Xad#Ep{vUNC=;1=qQrvmQe*2R7mdepCj3ECdF)`d}(r@;%(J4f)!@zh%X zY8}^GtGu!B=v-2m)%)8jV^i&L+AlV7PS9-FtL8%Rg?7^G}e36R0W*v8gB?|*bzqF^X? zf;a{~e$0(-yfuUw!xNMdSow$ZXR0)Xf1UXecy~~;qpKjxMm3$uVN4SybTGPwCVLfZ zgRa0S0My-W@KcMq2z6E72M-aX-Ek2i9RQEJHovPWK~UwgZU6ym|JqlbDLv`W8i)WD zpjHDhnF#Dm1O^jPJY;04V1FpVV@!v3zv9`@0Q<57Nz*gO|1?byNyd07BZz`;wN(fF zvQ-DT0T9nWGjXic`sj4gshOXy(qLsg7<|#a^1^Xn?1+SIq)HW8De3l4GF*7g(?p{(m5dc{p@;5FLz{E;!^d9of>CUE)D0{Sq@F ze{ccY#@^=#rLyISOr2wUX5rFpW83Q3wmay!W81ckC$??dw(WFm+qO>jKKsM_Bi6dA z?wWH9(lmd<4$RO;qUnIbwi^bbj@svmO$F;7tyB@iwV@7m&~y;HR&TphG2j{8 z?r^GkG^|fPj$hFstq~pZ#N!X{ucbOh>iiWTB&>ZnUzw#=iavC`ln*E{WawpC>JQ| zWtu|Q*IK}%8H;!mIbpD%kbWJH(xw;Tu;~WQ}zi~Us&Ta z1Y6#B%IVg^D3}sN?1&-K@`KEZ8MIV;!a|ZwubvMJz}`lkRb(hcvoU>b&b|GZI|W( z56|5C8ip3fFxIJe+uqDnv=Z4vF44O)@zNVfUFpT51)?qi~WwOF;wnfa-FL% zc?M;$rKKwZr=e9BdL5FR0JRNns(eLH3h4)Ng5zc`g(#Kazu#a^IQS07Sh zV2LYk)vmwfA>j}8?Mz3g(ccwU@!DE!N&`u*+RV4vKjqj#FYmk!;ukfklqwy&S}~A< zhMJ)G_ns{=O%1I3aZsL6+`JVaMLCyFNu%za`nZpxr+3bF@Za;c03GiW1@#RJb+$96 z9RyY)mtIloO6*EYy=jCX3mgOjfzC3Ls(P0{q${FP_f5NYtoZ&sHF=9$GuiwPmf z4%R8ywmM37O!GIi01saE))VIdqC_3J-@1t98epix9}Cg$teja0$?mlAlZYUA($RqF~;nxm-g~RzQZA7m58pC3|D|`>a0Q~5dt2furg3p9O-A(2Z z?#rA(mmtJ>T@qH!%r^;jDlY^?`i@*4el<4pDh614c&=tyU&zEy7Cl0u^v}t9;&& z92wAW$$QkwwH(-b>)*TrDcN7mUNS2YCoTIFv!d*1cWU_oTkjK<*;<51A!DXxI}Rk& zu%`AqZpVXM(6;o3FZ_X!5mnxNeoXSN(MT1=j@v6e0oYN*kN(QmR8^xZigZr?Dh}Q} zHGyd^BQGQ@`0bu?E2X^7c*`T}^f-fS2J*@h_Hp%(cz`bcRRv-rC-okFp{$e8L!gi- zg7~eP=2<4A*RqgY1D!tZq?K`Kq=+WW7&HVzG2&K9>EzL_Em*?eL9$#eZV1o!I9 zBkM$P6|g)~{KY3hnhChcvRlm(BH_eT8ml=81gBsCi}y7kqlWl~e~hbo8lB-j@ZJ*na<{wLvz3=g4#3@IY6Etj7%~C4AE)qA;lvUP3u;Uy?jX{&ZXynpSf+}Y+D!>YOx)Z27`WM3Xmk8Tbs?EM z3pvarW;oVsARLh(3Q+^aJsjztUDh=l<^9Tz+X;@W$}YOQ6D#%53LYzr=I~jldul`O zT<|eSs})lHl4Sq5l`dTn19kG^?S(Lc{0!R3NId&m1^eMFLzCN8+_q3*z21=p_$o6A z0R(6>2oHb%@iuIru}&zV5`s(ww2rHjjToP_ChGZyXd0JoGyOKc2}5TXElY!8cB;L0 zNWj78J%eh;HCB3f^b3abi{FU@(VzBW*=-m=p!0Cd`?=|+j&N00De#2`SF8IX07Ca> zR}C)gZ%{LqBANRyN$n4IV?A=Y5cURKS6-C}WH%n(qGKY-X=m)VAbC<5j+=#K>p`AI z&vT!0OL1Zdq{rQmGh#`tpjAU@lc~%Vx#`w`GS0;6Blcc4o&q04;^du zqz0G1A!)_Gfl<`&ih}8k&#cQw0HME|ba>W5or=wa{V|O&y@~TrJWO`K7C=g)u*rXZ zS!rG-MC#JQOsFz_b%?C0veNGQ{|>mJ!jU_v@-b?bBT_8&OXCABHru!EYC&a-XXK-? z(&H-pvVXaO@b(Gh2#Z_={XuK|gMay#dvcd)SNfNb>55KiQnn@qDhLutE5U#md@WDFJhKlN z0qqXs3gz848lMHUwfoz|4hcx4?Kol&3J(YZbAjV0_R6h-50G(>+X^SGT)|AE%=!}0 z0S>j4?|hgWI68SMuCDOHcT4RJ7l;;kc-H4o>J2(nl3#;{042D*Dd4;~aeBE#QPwZZ zPE2Sy+x;Z9ASf;+BjR?5SP*u*(E$gg(I2&uZ)vDIc05G%?{6whG{_C%g=v`+0*r7t zxGZ)oOS!q;ea0eveG>}fm?&MX5{5$#5pr^Mo%%rC-E)8ICt1tLNolLQ*>tvwB?YuP z?1rNnBk8`{@LcUoCIIkL){LRd#>U5v=&h|RnflElp=Uxz-R_u=1dltW=tw0 zq>?Hkg#~>XXG{#jj0~tV(H(k218+of-QNIjjTb_4Ll0lCxIzCb>@gsOD`8f<7(?kR zZzdTRe{edswRmms>JWzKPm{~Jg-|gMsOOImj1&@Hh_@>s1I%+8LW9wD`l^0 zp*_9R4NL?X`47CmT7VtJH>xu@7>UU5yrd~P0!V9!8iPiXZuC~tT%b*%(~poBsg=ll z82t_t%AI|+lvgJHBBk~qO%rcZv%0oD4vEwvZI-O4PW-C*r*mtBFiIVZdFORR?c zlphBraA>}3Ni!;9jb2JMguW?VQ6j68+(kK_j(>j3K&Lm`A>`#mB0>BDEjxIDgZkB8 zBiYQp)RCj{s|(LD?@E4eda90Wj~!6X1@qJMw1ggf8DPY;yH|4g%nj@iISOcm=mwgW zXJeW*pq8&1sDtm(XZUeRdwuKanUy+~{ZxlNtvw!+;}U1O8S>yCu-k}Fo4Ubyo3on7 zu91m(&xf2&H3GrUv7&;0#VB{AkMoWPc7?Ow6ZY!QNTNFU2wG4v1sO_e{pvmO2XE1< zGR#Cl3Bcrf-DN}I;;4lH{-PL`#!EmsSBcFnX@rhn2kDgMYjgOS-peb^h~)-b_}vug zB=Z*-3q87PWX;RVVNQya+sGUXRdIK^Sc=jEQqNpPIyAp?DuXC$Bfo;s2>UeXQk1Th zh(NEmH4V=+(|FgTb7q2F7|ibOP3N_%E7qzZ55Vr%UO!BdN!X0 zW8Xw!nhs$WhgIw1j^!bXeVfj9w{0@GKqI4u0~LxH&+0`k=Uoh}QM%}~L#}iOe6F^y z1%PV|-tuBxFKPYoZD4+JI%;os>4K}kkDuj*dy){BfeZBruJ<<;T#kPBizClTzYrZo z`Ayrsl)bLiP53N=H0!T)%#jd`(D21}TpA#xVAu;C@7{nQRyqljX1mIcL?Lk$K~ye6 z?Le(T*=EaY_tpf}O#a!RMZ>ngrk5_uDgfD!IY>d>_!&pFt#GolA;of18Aqpe{7sW~WB0e0=2|ei3DFUnONC2_Kcd0qC-9JH&1UGo`1En3lez#|TT3t+rdqC#t zZ+{ODoxqymweXtWF*Lc_{jQSYIDfnXU)zY$8wGZb?}u|meI55`ZSAOAcFuM_BVvrJ z?9ZDB#Nx~b8UM`5t?{B^EGoBWWuV+WBRH5tNn0lU!BuuKxVevkwQ?t;+g5Y84&@58 z^3xa^9a6@@eoF<(=U4W;Ec1abS%B?MluX~*+PpmqN!rWyVco~b`!O)~#}o*n?>@Hp zPy^#x(PMUy5(pX}%W6hGi(naB-*oJmWkj@6FjAFW#|H?v_r~LJLQSw13)@kwB&i53 z91Yqa8b5Jqf8|wA*4}Jj+Zx+p5KGS{j+aLzO`^_)tih{%OiVGqbDuggCcKYN+~iU3 z;x}YQ!TacccQgjZ+2OpjJFFnLPt6Z7uvi zowX|441A-A=Ab09l=uYr@DI-ryuZn4JkE2O;Xt#Y>DUO{aK};nv^`(L{?;r7eeAh? zm!}e>yqACmco_y=ThkwRyf?I3?2Q1kAew5Q2fw4Ga2e%}5=we)?};AEdzUM;i7-H- z7Br@d*9D8~Jxmc9_D@>p!PA*Im%O}}L;9Q9_Ku7wRUWJR;we9aDS=P)zHeV&nL(ce zDy86@8W=R~EG2ZZ`wbm0KEj$;b&PU$+Q{o41ssPL-fzcO*jDx0Q1LuDHimTeiY1(; zuVF|cupkQ4`rgaoVA(8=Y@~7pEiJ(Ep|=UQu8O`HwS3w5lTU|B$@+zs5~9e~l^jJo z+Oy0tInB4>hL1fY<$`9yB}34bdX7O0IWIpZj{m>h^t9}UA52X$(a;#<5G;fU@CjXh zAQaKRgNYa`03{Jt_8%914M@F_5Eo`5d5eiDY+53Ng(XMwfh}Hn{pUQYClP@8y{YaR z4*#E%Ry#(IX=69t1+f}k)wkil60PZuIQW{4Zj@GcnK9GND+CsxK}T$N28PLrM0$5xs*{*89Mrg7O*1$0YZQ5RqV<=I}(%N>5Y}6LHu{oe>W1cg;;4TY1Tvu z1k}!bHPAn{FLDWwjGox&nglaUFfB7;Bgch9Gf?&lhjGke-sStkpquj^4mGg4u&v4% zT#m6T3)tI|X+o?(4{ZaItaQQ84%~yi^4hHoF|^`XyTUf{+qNhG39Sm z%-Y<8A%|JImW{=i%pxlRQ{~*wKzcyCn0jk^7YYF5x6YS$K#X>cqF@UOnpM$3-)apfu z{4JWh9}Q0POX3}{n1xBpzuAc=&v?_*nNF?{iG75b-aDUg7afuiAA=}j6Tbea_T~^sW@>N!xK+x6!|3VgNQ^p?@_5i z>&+uh6tWnNh#LyH1Y8U8DHfS=pb!z01WNi-0&3=|B1r66 z?uSG0%;RS$D!vd?)y&`{%vc?5l-?yCpZWx3=o3FN z7#sk`*v2R&X#xQel;a19@t?##2n)ym|0`ZBf0@5mrd zkn*%s9CGyLm#l(ek5(3&_={uodutUkr&FZYygXDkN;T$It8$v4fB0d_mQ^an?ZKmPV z_hV>ioDQeyanz_>7fjz?QojUTN;S|ev&AMLKbt{E`wNUPBH3|1jbD){`(qtdy(7Vh zV(0<<&?K@K0Y)Ih17r4IiX0~242ns|<_Xzn!i10|dxx23l;;82q^QCuZvd_A1wJtq zm0Z_9$RvdgjC1Mghvd+w7d-k*YBP9kXeh{4n)q4{fniXc#Zq$pm;d;V)S`yW)$KzK zB<{fcF8mnn#61wke*15z)2jJ1s*IE#07F6oKyso;mF*Jz0Riod#1UkDSR==M4H^SF z%B$R1j)vEQ>fjUjcjTI;JOIUoodEMI(-!s3L{;T>Pf}VU_&Ek_M_GzNj@lW6vBL0Y zs!EP1zkf$Qwin4R|E!{Zjrw5n_ek1)?)+r5l-mf2yQi1PZ=^DyBQ{nBv^1F$-d*hi zf?27j!<~;x>mP~Wg_m83tLh(^IUX??ON=+hU9*bxIXqv?pj(U60s$0*D7&)IAjTDq zbq4ZNM1hzp>#8Bt@Eq9W4EGL?ZHUYPJ78~rTdl73O2BKl^VB{Xyl=4F4I>G9z>-OX zkp3dew7@L{V#Hy%gQ&$`tOCzN`L{~cgv4h%AZ!9FFKW6Rrz0AVk+F(am zo-d2DlvTQ_qU>Wh9{~91s;HDjw-J+sjEEb!AN$r$hFyuO?8Aod&p6HrQpTn>!Oe|# zrs)yuqsRlPM}(<$vy;P+$0mEb?STD3^A5}W3uH+=WS^Rv!cqLz&WmQ*%3J)kSXvq{ z4+2}6Fx_%gNse@!rTJadIOh-4x6y?~=L8YL=sgMBofv5w0S@S!R&1!f71xw3Cv5aj z7yWu`rp38eyf?Wjx68$R-Z*Q62l-^I^lH*b^ENb$=kIM|lT0U&`ZST@!qIBy5kbI> zew4eOPf}kRhAp zI}Zv5bhg&aPVx+g`{9KA{~lNOUs?_BhCWQcuddB;-nOqFvELJ^4U=nIe@0e8@$%6H z+WDcuJ$GA0Qdl)(K+x?@Eul5Y^AN>8xtO&5-4$4THUTUqF0Oa4wSp3>cR(UB zqI4mQ8)VPcYSfVrgz;yKf%M0rp)PtFYCvl)UjwhrG|Kb+W<5k8v`RX9wQjvlI{nRS zecDe4#4SfUq7rK#jtkZ6`38%rMc%oV9KtK78{B5Euy>>@5j7 zX#F6*0v{kx7$u=o`1cs3_e@*>c#;5Qyv!M+4=mqeWK)IdP}v=dem2pOo(>3J>5i~} zvtd0R1zfFMYdV(lYYl@O$K0*i8VlkP#T^-R-Ni3{ME!+alVd#r9@dO1(1)mFOLdqT zI4Nq5BB@S_CQNDha@=GtAs;P_>X7S(F#~dG+rC(OQRv z7UK$|ZsNGqz&vAgB~ysZzFp&&Z-*FW@j|Id&@=tE-?4NO8!QS(G1UF;X#%F&bMwGM zZNAMMxs}0u{00!OeI>B>ADx2)9JfnY)15fBM`7w5!?v{Y%JYs#3)mXD4>omsGolJ^ zG&aBiI$ZUQ>UonTKNo9KzQ`DT*j6Hm-$i0dOVBDck_LL~{X46pZMbtw{-uqx77yFk zbTOyjVy~~dBTw0kI0|*ca&*0tP#5cs8}1#GcbE+ssjD2~?0&!1sm*xD_=lTCsWR9t z=7sCCKc5>-ki#0FJGtdwsQD+ZAX}0i%_ty_n*t;UB&icfMKLJG)*W))sEw+LL1lvef)T3vWEjJ2p7vpL z_xWGg?(v#W4s-;Vi#x2+dq@_1S(tBSaPRM+v!(o66Z*I5k(Cq3kszX=7tXmhJqeJ2 z4C|wI7=iSl2SPl{15%O;{Kf@u!+iiWk&b~d*l()Aby+oQg}Y0W=I{Jiat}V0-;*6d zA#1FN%5YNcANkJX^{K|cUB=D37q|v;jpY-kD8+>$7l>u<>fXXU*Uyi zJv(%P(#8FO{a?%eIepy<+bP(YzQG;008u|pu#TAAMH|rEPK$A@F?V}P z4<@)u2zno_w|^edrI75pl?9kc&Z;aM+D!6ihI2-^8l#_7p>8BYej6rX;16E7CiT_P z7BE`pa!&-Xc9ZdKuwEQFpx4fij&>(2lFBeZ61Y_MCxtUyVrnmgfcR_Z383)I1eQEY z@f3dvGpcf^XTR%n!bhqc+T>JovzzZOJHd^Vsg10@bv7mJJs*)8q?$>|pUI5077GH6roEY@b0E}1i{d6|7)ITY8FC{k)tbkFzm|FDC7{au!2_GC=ogi*i{?QFK& zd}nI5y{0f*E?JsewQGk|O_#T|`8~h5(P5`i2HvBm`{M>Htj%A+id3j#m5GM9Q#;9*ltF0N2D@<-OB|FP?#=TEOp_Ohx1Lq`2c zwaVYZiJWRq&fL$3nVnLza)T}!O%A1(^RLG9^8M;Uimu9K>($m(ZDoRw%(r2{KK*6! z3Of9ydEH)`3|2~OT$sx6rAhmS?dF!y7n+So&-1t=CZ)+?F_=+LC8G9gw)x?;10VIl(rCbbItkP$V^pkBA3yDf}<*A%?7i*{XF@s~uNyoo|u zD(f}X_h&V)9zU<93sOPHd5yJ%=HY35g`wu8dp=+&H}DNfb8_>^kq?wBuU6so#OCa? zjxRA}nn65SY`I^%vaY&$v75JXr+B4p7d~@3Ez{Fyf|Vv=eQ*}+H%BM^n#1`izQMb$ zeO7jats<-Ts)|VBFYpaUFC&US$`l&qKEoKv>Uivj%OZzz1~QC12{FSiVNBM)V(As1 zi%kJEWWPC!yZAGo&g+SoEV??Y#Cfk80z7-VV=j|6xC{dR zx{ybvNU!?014W$7##L&8+fcQqi>DT*<7Go zX67Pd-E9v2q%~HXiWJNDh{rsIA4i+{n*!0z+dFBh!S2^f;wB@0)oA?r%LBI1d3goc zIBDNND_N55+bFkp1hEtMgdK>G6MK;N)>M${_PLp5X)PF{UcFG_x=Ir=); z0mVD3vUh#XgV;1$jxO;ahHF7KrxOVquYwt=DQSnrIuut%GBA5hbdr;@*6kt5;*b&m z)k6P@Gt#0XZ{PzsHEBDs8D=-9dd(SF6yM8<)-o4>U`6BN5aS(z2eZdfAPxeerN`9M z*>#no)R%4Phu?_=?oz=*M{DnAYEn2Av;jLf4$RAH!I(pbPPyyC5G5SM_SeWko2OCGsuHL|chOX= zcU&E-@Q=uKX9gI;T;l_3Yb*={;dev< zX7WXE`G0R2Z58@YkyWojS|b*fv9cGG*=JD2LsC;It}(2Ovh%8xCR~%IPEL|Ktm2IQ zHl$ZMulr*ai4V=BWF1(&eoxFA@g127#-cE~k<~*wvQAPKBD+i&)g{9^3JSiflf0Ww_(lX9G*l^6L^@*BW-V zx#%+>DSMXm{;_56r3}2Qc39E~>0{7H4NV{;a#TZ_Iq$W;!RyXih`N0r zd=Vp=JPyP^wH4GQYHSVQ5h9A3I}_ga1jGm!Yeaib_f-Z^k8;^69M7P>(!JIOZ*F{W zH!EEg>|cQ9JN6^Lin7xP*Ll}Y)hG2Oa;fhmhkW@|nzNQ;1^RKjJs$w&F0N#aK9R(41K<*RtCKH|`zpV{Yf=QrtJ4Gu?g2*0l*tAd_-+RKiAX(*A z3IM4zDIFMwJ0p=-&XdY`11(7HKFi3)q0SIdgk&}f>WYi*+iG^QuC;xCnp{1#)Wh{v z`wOsP8SUW*mX3^rO#-1=&_icINw_Y`Lb$GXJ2x*~7{V2^lp*yqkKMBii-T#IPf&o- z8PBODG7zUoQy>ZY=og*lYmS0W_Kp;v-Y{Ub9VFhM-@y)(Pg68VxASS*i>y0b4)uSn z*TFouP<4Lh0~U$Qbiq(@Q3&hH=YH6Xfd#M^p@4FT9mO$r+L^Z8o(NW%>QC1%b9{2& z{;ZE$QCAx1?7E2);p3%UG{9siAN}x(F@@ZjX9)y+OLno<#8Sn}Xsf5~IfbnjTRg?k z2RP3AI?n{?S8)nES^N|`FpnfTS!Y{$QmIMVgZE;KkOPU>UdA+{;|-kASDf zTS)dRJ*a(3x0y0x9cT18v<0&aAFFCW|!s!$J<}uf$D~ zOI$d8<=XHU@k|VQ%XkUud-%ngsA>OcQ9~U6RwqMYGchHYqbVUEGU&Ry@H?vdt8}%t zycz(n0DuKG(Vj5i4aaAGIRP(h-K-P_mK;i8=mf0jUfEt)db_y`ta!r{= zdKgKy6c3)>Juo~b08X3v7^D5C$Is3TJLAs8u3^M&+1Oa(y@K*t&e_zQvX9{XY2SwU zmJv^DnM?4y%MX%pQ4%0gBb{^5bXsz=_8_5?;gfq+%H`Dd$#d{6ZH^nA0eksg3tj41 zNU{35I*>@mU6o!xluyZ<^7H*SUSKk9l?o*spcK;r`Ic=jwbY@@azA=<>t!>*en*&t+D+HoH}_V9hNgiGUvwE)hg;ZPZVVMB`A zBVR4nKs@i7<1OMOyhVw$Sjh?AjPU9}4&R54nD+2G@;ZIkJG$rRnq@)dfm){Kq!gF- zswSAPzvNIS$bIl_k?e_Q``ghy3V#soi5DZWmTmc!ncr^LhEGh>ly%hLJL*JPrE@dk zWu{&b9V;{MJ`p5^Jp-nr%RLMz=bi9(N<+Lgtax1gH8<=HK!gk_xRfeG{zX2mT3GN#it##U9+3w(N z`1|&~D>ocTna~E}N1%*Q$cmm(LvKJH&KxMgQ6z;{s{|*pWdlsl7BQA6W^G_9j5t_W!niL`(Cj(5- zV5pBE_C_HKVgdGpL2YGi%0MpjI!=@dX#VZuR6~-5JM#o>@*Q#%{rKodPlNuV?2kUu z@OI0pLjpgS)${BIA?hq?Y`_PDNfH*bPaAQ3wu8+3$9{?zAqdXlRf|kMZ~X=hU(; z;?dO5YYgX#lBs?zbpKAr)$@5o1IINuv|VUEV}IX}axPkUDU=abUTj|$=}T?vO7WtD z2$rT+aa~t_gk%>WDuq-_i-Aek?7Q`^t2su>YL=xU=9Np=;>5Ss2e?#N9@Qiou|l7C zB|4)5W(M=tYjc6VeI#ju^}Gv~m3_jJrmfW$6bHNb`yP3)$szw^JN>wA_ysq81(zi! zTBvZNcg4!Gc^ts_;wDUlC)BBhxeJV@oN-SWj7AFCG|m&?shjAWx%@A2LL^>?4q8|1 zRN>h2o?G>wtX7A-I4_@i~DaprvH0b*^*}hW`88(tm?E=lMYxkPp>Z=X|T>tlnq&;kgH};kF_`Q1IApdTU~{7UGR+Qs|J3y2cR3l6iEalvvR1Xqxd=S2^s9mwA*6f!5- z&211VdC&ZXD&1py;o3pl<|-SOSOod}bngK`h!g!NND3WPOH3gg&zxPH6BgP^c$2sx zGC6h+@dpUxXL(IG2}LOLBFzBUb`Ij9yA*~7h=*Y(n7CB}rp;9Ow| zht1V>{AD}7AZyDDGa03JvS4)3xk-g(J!mwT#o!>Ct6cA6Xj6D03HUk+NZ$NikzCQK%2?_5NP~h;j&BC8xMD9D1PX!oQ||FErsnG+2l#xG}ec z{Xz(+v(yupY8t;nJ<#g@27J+Ymolcu>c_!y)Pssr@my%6?akrywdADmwEjUYIo(Sj zg^f>bLqibNlO-8-*VVkq=D&avdqDsFr4eY_@jrU+B>)!K0#w;^; zN-NL@#K^W>fW(ZpbaLTXt{Jfw`E*?Oo^?vC%r2BOj6-BY)RPHPjKhqneTZDcx^HK|q=*2t}dfDiEFKs%!PRr^=cS1qSWAP~v z$k795zC26lsM;qiqMkPl3yRcjB^XVw7Z;Cw!XS)Ylpu@GdgGrn?|;r3kS2KmS8t9W z(ZD}W;7NjFTvT`y*VWf)QAOQV(A|=ra}3zyUjo>I&#dwD3I zGr8^9Y(72y039I*yy2YMHk^SmPQ{SSS!`txf^q8Sj5^}!FNwU5_}I?bWtp`E2Aw^# zeFg;FVcWA!Vr`sj;=>cmBfRdw7mVTJxp+j z-KDRg$0C=2ogqSCSi2V}9d~((jWd1Xv+xs>5eXs|!Mp;1NvaG%JPTX?W8m_02c4BYtJF)DB3q9|7K3L3DsH^m* z8+T9%`{R~Bd0B9IGbSI5tn7iys!k+Fa0nz(iO7ajVAKR80+4gBIL)q-5!&qZU#cQ4 z8##FZO?6@p2XELXC}KxU{n_~#KKk!Fp0f2*wDi`|4XR- z3~DC`s9+py?1U+GjL1{~l`)%j#{VSL+!}p7`jtro@&#I)Itu-4r4hrWRzZx$esl?6 z@6lC5$rI#lO}@a2gC|p-_a@@nleX2^>g=e0lLO;r0UtdXvh>vkGFae}bR_qYYJXXq z1jzX4Mq^Itj;Y_czCFA!D~ZwIxM9QgI2#GnBrOCZZ24KR%Tu};6a zE?~ix#QP0$$K%)HtnNO^#>D0x%2-9Y?38%sp6T{1&Rk-U3+BspE{gU%ne^d+(YJdj z(4nGoLtaL>pRXLZUM$op&YPJT$erzrrl?2^1r@f0YT6G-_|e46-a;)^j~9t$6Y^I? zSgOq=OSIpVTSfsB!xUs+T20n#Rf|;mMtw4hcICcdjyO_TvvTz@tv@do0wmQatw`Sg zYLKMhxG^XgD+8DSNtv!9*j!ww>G%#)sX%1bxNqImUGIksG5FbX^Mpzp0o7Tu7#+;& z$L6Sm*ZpEQw(|?tUJj~G#y%@8QVLeuj@Zo8Frn%>H`Rc0n3TjmE$bc1MaUGg_5Peg zXqb6CO*2aKB;!6j?FFK+Ge=hQEL$&~B*8EHNOm~uZ!%c2k)l1JeI;Y46746Zn*21q z%5!DQY@5jy|N2}0i-|fE_&K;gcb`V;o>;w5;BEEZF7NkXbOS;~Tj219xrYK=RpB9p zHa2+CR+oSp3)dcJ<91k#c-((NVr*O1+%Vl1mT8SKEr|{n^1{7bOmJ{d{iPlFjy?Ty zs|48b()MUt|A1+K5sa#6_N>0eQWlCn%Hf{m4z?){DD@!tVa0mby$8-h1sD9RL!}%u zd%fKQdT}p1yWu*uf?HnBjOgb-xw6w{`_<+X3+12G?vH>rS$SU+z0k}ETVjoefQdyr zKTg}df>ue(1Rl!fJL4<54=-la2)oR@zUS|s1yhvkpR_#AxtpJPZF)9TDpRP)hUn~% zPO>2=<&)`*s_H|%>W-_51PjZ12dUUl53Px+AU4)2;Npb^ieKLc)c>Bd^*`w(M<)kk z{gm_x1Q-xb#{VieTW;u4U15P)Q|cfSfmUF*Cp1ry+$js8Xo6BdRSw_Wf(JONR#`CgX(eO0$`?- zWb$Fqj4-y!b|(A{`T`he&WM62@BQNbQ2)T^I0fU>^nZmPpwpr<1|!-blH5Ppq3K$| zvIwuplLAWeX`u^Bup)p#%2M^1hm8!W&rcG-~F4d&kUV>8ZNOb`pL z;u*v-Z)}7oMvk|Y5+}2hOD;nva3qhn9M|X7X_T(7>0|Nm^kH@PS z3F@}&oV->t+g(jBC(nu2I`~xY3?E!((IW+E+`LLtOm7F2tv53GJNj2gzI83luVBn;!VWX>rSpa z^e>2lRi$Ph?E74Ij@0PmgfG2z-}t*thJXhB>!Fth4~8gV=#>*th%@OMcAVhm-B~kM zQQK?GUh+3IJV%oxRcXaqPFi3BJ8yFvmYt2*szBKh!n9X*$#Bi}wVOtvVli+=SqQ^5KW?<_9 zfY~*+=*D^hU^qG#r8;MG;oQJ#2O1HNNCD+?3U`sE1}}il0RLA&(hM14vnNV)3OIN! zNPw01Z0$j0L~`N5E#QJ`^te6+F4)G2!= zTT70*TfhDWj|QPFkil|h?dkle?Iw~ELarXd#UY<_M+RnNpLDVIo`cZ8yd9=jQxn^f z0S!rB`7ZDfY!R+wUu`TpSBMRO3^NabKAzMX z9XA<=dvF>q63lWAF}v(ZDl5NjLPfJ(KVwjSLMq6*SZbz&#a4pc>y~~@ zcFT>zt1853{2%Z+s*M5YC+sRqH)>v7046`4rccM9GqjF91HI^J!QHBZvM% zf`UTrsISfMXLnlnrG#n*QSRDKk%`EhcANv@WGlHRGBa7L5Q5fkOPF^@!Yq{cRDgC5 z)T1)3B!Z$#>4YW%h9l?C;HPVlg#88n z>^p{9hi4U3nTBZ@1kkf~rfC#kv4-84l1!qA3Z|nu5vGok{aU)YBopy^##`=FM8dJ< ztR8TYje8of=Mtju9I!uB^1W!eyZkd3+HBCAvR4RVpED$XsFB!VqyoorECIO?Q~iRI0-BKe{6kY zbR=Qhbj*!y+qRwT#x^z^+nm^(*tYFtV`F36=EljF2j_e7yr<@LU)?{t=gjoEyYK3& zs_MmJ{C=*~bt#20IGO`!LcKF2t6#B$kj0(7CP;@(e!7YH*m2sG**U&-$agL;Ej~L3# zEU-1mQPTE(2yVt*up@gqhAOb9U4@3~A}BajH@`d7wD6Vzhvuqy8myqXQiOrSn#_Y{ zWw6uK1lV-H#z8sb+YRt*YjzO-`;MPfO5s|k`p{j3%SUFb>)*Nq8-_>Q9THKKw`+Br ztc7i@Zpa1S3>bw(Ir6uV{-`sfF8*Ob4(`JX!9gY*q01|CJw!E%qE53-nbJ|ZF31An zr>Y27Bp!!Khcw{i_)S{N4DMCY{y8@InFst3Gh!NC3T_-Fd?#c1m}!s zTW%TCpszm~p`Tc^hyjm`Ks2H`uP&j#-f?B(6vT(K2>`{Fw8m?1;k#M+Qnx$y!hR%Q zg@*)+^lVX@cuYb|(ZNSM7$H)pE^TZY^0fq>Bz`ni3L1t&ep9#b@uM>SO6dMcBi;Qi zS*OgLxS~MDD=%Na8q|=(wv-x~z0j;WCt%%O2T{Cgy#`|3m`;M8j>0dg{M$$R<0^fe zXiB;?KueM_c2*QJ;Y)zV+8>E(qk2FBLb>FC+6qBo^*o9?LccTCp26B-BChL?^0CHj zJZij?)3}_x-LbKej~HgadgA{)yQ@9(>yE;TNZ7h-2ivKN{YbliswpJP3NxEdu5yXQ zqze(pN#a-+rM(LR>ft+vHHI!mDcl=OM9m%v;O_@X$$IO!Cd{a8*LsLNs5u3H*~Y4= z8JE;9)UC6sw5ikV+tG%??NvwQ%DLx@$(;Agz04=i!re}14Yb+aq4O+WOi01kS`bem zq-)&b&c}^>y4NJndvsyj$GWidltN>?LILR6aI=7PlyLL*az@m@@-3n(J`_>K`j`|z zB2^BH3WXDwk#+vfuu3jA3y-OOcJ|RVdr^);o(JS$!lBX-_Oe_spE*>z`0pC zS_Z|@4nR}hl+h4UY_>t6Te>CDkf1=n8vV_{(7;&OQ$Q=fGLsgxb?nwS(S5&6bxok@ z%cYfChILPkC6b}Smp~Xo0^-d>Q^_saF^1nC3g}mw(8t)xiiWc3`{$phNTweOwiN8_ z{5T9Uxfjq~syWxd8ZQ=%RQcnmzVEWMk&6NRy*JRl3amM`Ci#vcQ)9Dyr7V-b7rVEm@8^jz_ycg|`1!7_#5(IPe%IwHXeuUu zP9u>sVg;DudgaeRkzkJ!f{5V-i>wi=N93b#nIvP-Q?)5tpfp?K9pnFowMGuMVYu$E zSRm{UL#zL1LNxd#u1zqqmF-AD6QGj7^N1UIY2-^dM+{r3UeJ5tA zCX$wI4*&$$iq?%p9Vm-^*+~|jp$()Ivff)busU#-JA$)8-hC`yx!hNi>YI7n*-&3m zMoPj^R0cn|pWRY-HjP5KvL&5xBDpdrj_;WKH&Qcpj$rrd>RE}G{^|k9wGki=cd|2KVmsT3!b0DHBj;0oeH2 zA6*V~v9R~ex2h+{m`6^m%Updk>s*qfGQ1sXJmKSEPiR6&TX!?w(`W9Lvr00znrW#0 zEPxAW#9HuuS7VZ#C5Pn*D7#_0>XpgoLBkrqm^O_G9y<73emrw%W^CAYl)tFBgh;Cb zaE+PLmp_5otp0PGP!zZ-@F2MtUKjkWE~8j0x#^LsC@UDt<$16SnzBH&{@Ry(A+(bu+Q?Q+ICvW04no&KXG=RW&Kv(P9}2 zO?rMbu3Nxd5WWjlaYev4!g*)LcD_=V%$@A9`HtukBdVS54|2~rD`wQMs|}(1mlfSp zMEM0DY=MAqFWukVq9H@O`Lf(w$y`TUy51axf%hO{dPY zAh&pBqQ_d!$|Z%ix&frV4YLdCyYTXItj94@9iTC&DTVaK#vGmTE>Thh`iEu;g@Ach zzE2HZ?s>R#BI=1LqO=@9l{ny&`zF%Wh*>N@P@RQ5@>awi-%2IkNG}A+#iJl1uBtbS zcu>52?yd!_z}|0YNAVQyHY26K32K-wR4%;~%^!uXkWF_IjwM?+MN5cD6^=8bE%1aL zX3}nBai;&o)toTfv9W`kXB8b&yE22|X*DA&@WE(tfl+pb zBfDg{T`!=9WRj*QAHME!_0M_4FbB~O2)XdgEw2wy6Xhu9<8E{)-tbzNv;tWvlT9x$ z3O@P`Fd6^em$=-srTTnV+jnMxXQaefl&F7FiC=dC)_?FMl*la1ES&$9m&eVKQn!Wr z#gu4U+2OZfyjOoQC9q%)BXYMudI<1aI@lSIkP9#y@B&RaJe{UO3|9?bkmnnL6gG`| zJP#^$vyu=7C&|q5{@25_n>Nh7sOctL0~YG3G~|kJo#7m#e&0e#0}UO+S;LA$IC0SQ zl4S@}HXFikE6o6Y2K6`OLJ`AaB)>dB08V5rUQfOB@Xvk^2hXD9DHqU`OXQI+#xPbR zrMUU$rrB)hWF`m^AIlH$(MwKt$_;lB-G4GfOr=% z4w|tKS!c?k{aVR;N(U5=`0tjuG%TsA1^g%lMk$b>jA`ktr2W)N%wje8PG0%g=D7k& z2uHuztaId&Ie=U%JZaFvE6{1sdZxRaOzHSp#L}bt=&SskX&H6OoNaB={y!WM>I+m6 zzSHxCo*HIGaV+B;5EcHmI<>0~u*M{Jook$eBdqdk~PqU}iqu>+v(pRBz12 z*6Ak`HM}^VIgwnrgs#m8gE9Z*I5M55WqXSGHOV-tu})6rzi^pW-fntpnh1aD00&DVa|OL4ojQDVbDJgu za#PzA3fQ-Rg)9i;AJ9@#&>Q0l8gg?42Kv>_&>Q^=FV1Zr3nVzL8XF25(;H;E!XFiZ zm(RC9t$eEnQ4^sxIeWR|BLF|H?PUM3q7-+v`gR46T-KPST($2N6f_IFdDjc*=(#er z_XvDyefT`Oc66=26`cusKN;3c)i8ZEJ~jEyWmU@~ZY3OCdN$~O`J8)oba7vCE@6Fo zdb#>`*Ev4F2SP(Xy+Ysj&lXqtJpS_Tn3+_($1E2YEyMg{E=n2+Ci%a5QZnKJ17*aCLY&addESt$%*+f3fa(lkw})W%@u!t9U56npC|uo=_K^423Hq zGm2}#0X<4+i8;->mRCQz!aCcU)*wng3#~XCpBqdJgF5TSu(5q!^@Podv!Uh>h}jAJ$?+cbVS3CBv@l?qMqb8T#W-YCqYpu<1W){h@NJU>^|$kS`8(8AY} z|Lhauz;VIF+h(E?dTxEc8Fa1FlMV3rnAqz{2)@}UFxey8o(70KI=i&l;CaD?3h&=L z=71Sbc!I81(g_9=QQW@ZIrAx|>xR{uoh^(;QZ!n$o5kj&Umo1-w-yI!D=3X^du1V_NYup!o>ZrTGK~ z>nxGG>u;Q3?E%v8dLw}5+$2s?CmL|9oYg$5%H0AEkNO>Tc2muEH3n-9Nt-;nOn?qe zUBYZ8M#gGRx2^Xp_D$>95BvFo?$OJfj2E`E&9z+g4|B!aN3PN7>*@7mcs$f;Jzl1R(G z#BPH5!*k=;>Lvt@vn186A8y@Wfhvrj&`~i}fi>c)$@K5W*U1w8rQYGUEhhMVdp}+L zcfdZYeED>$rWrdPu}VTUA}>bQ4h}!;Lp|wv2n1?jNmf9X(40C_OJGiq6k>=zZ}+eF zLy0{kLCWT$9({#U_B+g7@t4~&%kpG7&aLbjT=t$hE#6=%d+F|qx>&-|Q` zosnH?D=gYH`lpvk_gYVa>Pop=cYyJa%Iys)U81?G*p&Rvs_e5cU@=paMg{nQv2;aN z^M}Yi0%G&k1O*icnZuqxV!{H_9)tqOc@7gJzsy;JO!`Tf<<_FsR+7@J{a1gFAi%!X zD77Lq!>0KwReIC1t$_J_BWYDeTzt?idw{7@9gyjX@jnZ~CXFCdR_uet4q;jDM35Gy ziA;DQAa)l;CRzPr+(3#WG={7J1*#k5!_KRqr1CIek&ydS=*Y#Q0W9pwUjabQoXAnS z#6N48n&a(pL_p8tuF;I3LmHtaq>{qU|D{n1#yx8{Lb{w(K+VimOlddszPtOy>!?a%08;~$)zddD8ot%B zV@f-^qAc`X{WaMy6QW>tv=9=VF*;+Wnx{}_no%;$Y*>hg5_^w9?1QtcnVh}@Uur&O zwbc4NQQ0vTJde@s)fAfJrSkZeEK{i%X``2!5t!jjThaoUS`TFL*diH05a6TGF(a%9 z&bNZ>g+}=PppY;TfIjo#&>xRp}lvDl_?30r|u zFe=jCXDEH>FKxp1Ipje!-*Jc?b0{Rs`o!nV$|W%t9TUpGHe^Hw%*one^5BB=QGKbo z@|m5|N3m6F0Y-363RAhB^SHxleVUITU_OO$su4y})S2jkVr%4ynhNNW2EicMW^g3~ z$hr5YcuFGx(L~On)S2&^q1HYbGLsQx zQOtVp3&EdZEcN!Y`7El{ieRfDYhxI+U=-7;ZK4ube9Xz`tv;4w6MInyh3VL_EOgEO>0yB z;FQR@A@+{GnE2f68&hALu&9vyL?6vzqs8`k!!wjFUmm)iq99t9|JSyRDTmyS&$Ygo z-G|4U)~fu5rqTkD9W87J|FXedvYRKgWeJZ@=G@26Fq5HmJpjAF_R%hGbZ{1Co)m{wL^{BhT>&?;@3cX$iAKA-jmh0!-G#n}+iX?- zhPg{ig^zGANixi#-@WJi*)%8+$`}knrF~W)xOj2GZ2ECBimKDVSD%b1s%ZP zaol(G+o(`pJcQ)U_4D4uli)D==Jxu)ACHZ@PIgWy%G?0~hv*U~8~LO3&T=blO>~sk zKDK7`G%UfepM$Ezx>>}?eZTWtJwXIxB}Qxuh$ld?M<%tjv>G=1U&%4u9%-WzN0QVv zqOMtoW|uvp*u%i&so<6~2;12m28#hwhLoM@X#jVTfrhND33(>8HC0HIHITJm8evnW zVFOSjE~hYa6OroY;0jYSN*A*tmp^AMoCNZns~xIxe%nyv!syQIwH()l6Q0u~8y0+r zj7$B^>JneT{#S@+6PE{*P+=ByCD0YZVis{FFh&$P;k#rU=hD6C&+ht#xR_Fam0=v4 zmf@-{R};mPnm{bIu9=_x=UYV^naA#F2m~lJPx|kqp-nIbIa_N1!XNb)K~*=ZF>1c? zkl!PZfdP=Ud*wV&Hb3E3H)6#BgO+#IvQeJY=8tB5Fr#G=#@z9`67mZL_+F$3%Nt2z z7=1ieUqVX&uZw<*3}~K|yWkdpS?H!OX0l^!Q3>8+qF@iX7(ui9b%8MnYwK1kDE5lE z>jtQLAd?LOg;*DQ@#4&khC3{738vKZ)1#pIC*nv6O10)VVwfU6sQNNQ3C5if7swO zFsm0#cuu0K>wcFFb3u-gM~(p#CkIwx-5$wdza++}e>*&!bQ>_KlYgs>ypmI!Jq85>%G#~`Z z=4q#`!1;mADFssz2=D_60ZM65Qu<_}xQ*#{w}n|QO+?w~K>5YE`OMRh4Qmp!y= zyJHt4e4LjU86)vs&0d=5{5`2`he04M`tpyTcD(0rm~$SBr_N8X`L6KGMd$E3;Uhgr z5@WOHBsa~n8tWQU$X!S!dm)tTr=?K+{xQm zI`vzWAbqR!7LyH8QoS|_r>{2~?J-yB%`e^_73r*a1j#Fx65OqJw*50jb|38S;tQBI z3j<{(yDlhKh8KyRWU!msw-S@F(yN<6R4+c44*ygmbqhaG@AbV1t?={yifa5@&g!87yz`R=A~YRS#O407h96w>mm%bDO(9%RW^g>*5xDQ; z7+c~)EpGd5PZhGTuLoNXM7zFTpT0{h0sv@OtI4dM#TI(Mr#V(l>qacM7WlojB!nur z=CwD#(Z|eV(ow2nY7f}%9D;TN-oz|_!H$4Du>PYBGyux@syfuhf86nTLIyMbSOK3c za}eE(b>z22b?m@-e+$c1<->N6$1TyXqKS^ZjNdJ>E|;AbootIwAytFJnZf(K(*W5R zHb!v2M0KHh6Y2UVh!P|e{a`#)HQ0F3>+i!(95%vcl}IE2(#omS7BG}$%KG?XVdo)F zYSv8I6g%)a=gb!J6D^<>ShW5)*jSG!#rb zQy6~pc4W&43A0M9NMOP)ozb(@1mMOQq?#8bM(g|2t&~JU(r;25I6+pMeRHrsI0=5O zIA;jI%h%dUU`M7_k%0$J@n-uaWd5(h1BN;d_-N0~)EKAIE>A$wjeh1h9LuU%HM=A= zC0*ePZ{x&-hbsfYt&w%HB1Vo~!b^@a@JG5#Ojw>zL5OUNR}m&WH+HkQ9Y9dNVi=;V z5rG0t<6Ih=x78ur;+yx7V7GLhB&mPEI0n#K!%QI=q6DNu0#yce3Zd#pJ}g5p@K2oJ5Ag$zt4-eB7)%i5`uwA zgP>4QQ)YquYGK6ocx$A~#G@7ZM*S!D%i^UD$+$kB14_8q{K9R@gB4J3kvW?J% zMtlwZa#-OCJN-^h3c@BB4kORqKAdU?^O_OFZ?@FWJ->Wnj{fspH5L_c3)*grLG+oX zU$J=81c&sFgsQB7HEtd~nmj!ctF>;m@S&FfIa>k~&7~{$5KS(CK2!-VlN3=mO7p=x zU&=f^=je#kG#nwy`WtY~#z3X9muiBQI^t4Dg7dRIU39l1Hc4E#-`c#Q(V}NFYPE)| zG`r`o6t}nYfTIQ9KclNP)g>dF6#N4cDfxW)kzYZ66vr{rT7!QW__Aln zVrB?jE&`&=P8JE`+b>g5V+yK{li0oY7+504Ib;S;FzzDaM@Inx^9d45+!9n_7W+F5 zVZb5EkX%nRE0OPu{KL9@z?5&E%A5D>63w1@w&uWfuF!x{B$%P~{v{?8j?K_QG%n^d zI)N!ZlddKJRUxvJ$ZX8b%lC2-MByn|u>#54aM!B@`N+TuLTHf^Zj9*L7<5>Kx)9d; zg>l7cI>=_$iV3C>6@q7N)KY0o+Y+WtC4)|N-thhQdTf>MYifSJWLOYO8_)^>(4ZRY z6I}VoC-z@7B+tKT$dqYwG~|C79(3uf#o)J~_-xf|o7~R!w*w(Cp?>l>f|2_fo{)s+ zLQCjFNPep#sRBK^a*CMaAcMY+LVIk?g*OZJac{S!$CP8IP0}`3Wh6%hr#Z(2XJF-r zQjg+;QjJ{0SG-}_tx!)N+Ve@gyiprOvvmxW5w;Qlk>0CGRZwrm9Ug&K0mQnLVqm7% zcGYSN$p1PM3ANghWQi@aUrHU;b$9N=rI#@8V_V+c!PY{taLUGFf#bK8(52F6nqAH0 zy7qMk#Z`_}52p%>P%glBP%672jEg8A@Cw7^heR24e;)BW zCO;IBr6jbgR{bu;tjKt{4yc1F)w<(Rh@QmxNue{xW0$z7GjXTw zS(FOhp2dEBt(~RQkIPtOm37zXJjXL_h^w-TEPutZ*{^d#0u$xw4?v|Hqn>fCT(tDB z3=~lHcSE#bXVhG)gA&}G&MYy#=R5-KUgV_`1y3sO#-&uthJ*Ji<>kPvQL-to+*>(S zF(WWo;7r0)E@g(R#Gnkrxxppj$uDbR)_RqJ}|^QgVAD!CqmC|1xE^V^h2O0`Gxk)AUqIO3ow;u-pZDGMM_DIm?4TGDD`uQu$FecAJD|SZ+-<^3{qkyjM~%n( z{pqC+zniw_b!S6}2s3#rg{ix>|7uGf?5b;?=7)}<`Rth^dI6LD2t2+!AL1At^e*I$ zmDA>u1!;nz-Jb^W1 zc-ABYty_ux27u4MZn+q(qq92!M80nyuPr_N@hmOI#;?x-QTb0R6Jgt(z*vKHVLv#ib9bTa{A1U?f@k13b8`I-k;Ye*c^w`AGg;R zZdcvjZ)M*t_=1+9!~&SMdU zRM^iR5r}_9dA{Hj3Bk@lIPXz2pjJjZpqP!9v{CwFfM?cBvJ;4fmlI!Ff8Wg&&Y6sB zaU%-`yG;r(=1Z{GVZV(d|ATL|S9p>r7_%HvM#Oso5;Lv- z62h#spg_L4B;de(Cs@db*Fhwc16bqI;Si^|BWTp{dPiu$l45IjVf;pd?`a ze5mpqnZ!fOS~%RzeWVJjiZ1v?u7|%HxwG~X;UMZ81mS!_5)dX>#SJlEKfQcB!1$onQfRHzjIM=4EZo@Xkuu327JQV{|zSWF2& z%&a1rRIm}^CY06ie#@lFkjCCQ+7<7U#s+KvayAcQ4hfn2xH+(Q`QND{U4Wij5Q+e#C@Hz*N zskp6S5(gMsRuvH4;#2?Y3XIaubK}i0MTcj?pqFS~3h~q>&MYY6^auR)8AB-pAgV!7 z@<_=&;9?nk{m(9j4ibsqT_!Adihu{neS8oex=2lhym4NS8`71h zBLPO`d!B>#a#vv)OP=(L5;_6j&atKMYp~8Z`E7zU43Chb`GQVL>l}XLV%BshadQ%x zb}3#g`=CSiTXv&`FOb%2y4Aw~_B9`r2NiAO^c(|mYh8*19b*f&mrLTZ!u2rESnDzd z+rLgG;Gk7CUfpVS(9Y0Q*Dk4kHp^A5e%5?oe;-}BSY#*OG{uB5W^0rj1Y+v&BG(|E zZc+WJ3sys8i$32#*JU6U)CdO|f}t{4RnjPqAc0Jq(z zTqy46nwee$hSpzS{20mbnUMu~PLC?yMw(zXEI~{JxC&Zggd>9=My~mP9lA^(0H@;b zozM3zj~R{^_gnA9y0Otdp9Vb^)11BW41Q!fAX3dBG1j2?E4tkB3Z_mw+;Fz8)ivN_ zphv=v{}?^p5w#IL5m5nYsQ(Ah(*6TlsQ(AhwEhDtsQ(AhR{jJ39!3HG8b@uzJ2}U@ zHyY_Etrk`=oVuD^`r}4Mc6clstu$x?(In#kYHL_*)nkaEdxTF~x*WB-heG5IRxF%$ z@0`SVCk?Es$@(OTCsr^4m+LVK2x=T^m3GbM`iJvLc>e5%+pq-*zdpZmHtP-xzpKRaN~kB3a_oX>o~8 z0+&xjSkrQBU0iN26S!}x!zjaCcTax3VbRtq>iA!%9~g8yqS&BB@D_lb%Q#?JDusq}@mTuKHf`sQ?vA&+2*7&5VS zvdl039~tb`XRd!T8GpuwJAx?5$n$@8@9vb<1qXkdvaUBKJoL?R>3N+=(yvN}H>7wQ zszV*GBh1OMQ|GEV6fp!HM$AIitcb<{<8#jAa1mX*IWRCjn`79BFs3{F_R05b_7Lga zFW?RS!U?zsx2SnJS2&Qe^?O^W(==WXq9?MeRB&T-wk@%J_!RIrx$hWSCb-^btNg** zN%>4h#zKU6WdLSSNG^JHsdn70Ta0`!k&`857gaX%NpDPUe-gkjRX~M-vCT_%L(QN@ zZuq72+YPesO+0QWyO8gShhZPmhVO-B{1}SbBm?-XLV%gS0FAv}* zWFpkii~TPkeGTBQ`Gbcvp@WggKjDk|2|yJD1juzjWxJ5Qv0m$CU&ceyf)=`t}= zcidZHiVsPjhNLk}4;z8h|C?!$Yey2{|(9w-{mu_T;6!%>E{c`HiaR zJb?1NKFA-~V^C6($7xcM5=Q>1#MBo%ghb11%x4{xdB1+(S~27$d#hhz5*;!rv*JAo zDXJHyB2BB|!WkKMG}Qj^XAN-jhsb+A<1c$R^shZ-)Fu)S_$3=rEkk+t+ascyG=Zg4 zOHp1nqEn8xfkg(tSjBzJ$X;@8S8OfAr5#|=dz?a~uZ-1|;)uq7GutGvpXx;|OEaun zd3>d_Qdr+<#8XLq8b%$t`=srluT2-@AdST?VSSU9Nevl8gRVhl46qEm4#OFD_g3$L zpQyk1ADbEAmj>h9@(N8Z@V_NipTs^ZN)FiXi2PpYOz_QNie57{sq`8 zd-7nzn^^CDWABI^N(Iw_y;xOois9KB6KKShbg^(XGn+H9M&8_XL9~bjM@L~R~ zW*wVQC>9o!dT$UkISNN>Y+aI(90Ra)iK6FZmPeojo}$K$58uk^YMRu_R0ZVpKTDOQulC1R1I)7rL$jOQDv+OMeZ8uajcM*QI z7I3kgMmf`~W+`<})|V{h7tnB?L^<1X^QWzG4SL`dIgt|LM2w$ADF^3`CPP@p42ljW z{}c-%_Fx6#njKn_dqlZqT}uKIY_qUb6D}J(JUNx&>@f-g{=C9*d#xbwb#8MD>k5F?3Acv)VB(7-&$?*rA0nM;`1+Z+QGY?9CsLZu=-m6nVzvHKs)|msx zpC?YxDF#yqy~mSc--v0=qOCF$=nto(I+Bi20_RL83NG^p+OO!@#9`XGdZrueEu>ge z;_o|VqoOq|o?r_sZQR?ArwSaE~X~g5*uun}0G~10%tNo{kLMG{} zQU4sG!I`<){@JgTk`{}G2*%Fy&pcf~m(F+$#wg0hqsIR1=KiGnftV!;i{VhRH7qFn zS{URn?ZuITOB8n053igN9i9Ps#zEBZr+mul1uTZq zxM;s`yK+n7Y-3P;$5VQl1u9V{mKgS z(cT=W(U)#dOkwzGH}L8`fjo82J^dol*j}{(RlKZwv5T4hXt?Y({bcA_?gFq);aotN z>>&7T8Pyey#DVkz7%GcFw?O8?@!y2`$l^}?b%m;j<&+0BOcpYxaNj+Z3D7*qt9D1U zfz78QvNErURL$&Lz^rs7jPpD|dQ@n^w$XPFeT@XIhmA&xihj31;!1_^GilBVw+5gk zPB&hV<_e@zluA+=Qi5ue+qn_k!=KK6WgC@Ub(IS}p9N()mEA=ZvaF@(`Bpwwb9M@; z>csRiG7b4Ed7t0Z+Bq+!aN~-@{bG--rf@sX*{oFzE=pT1f9IPf&m>O)P27ay>lsho z(aKkoHCCA+8Pw`PD49XRRs>0|ng;epZlO}w<$37uhV!Rxeox#P7I?6~g3ZWkam6y_ z0vC2T4R)W)qRN&K1yH_=C9FF6CZ+AG`E zZtlc}_x!ujT?ODCq)*ve`+g|ZZS_s?kt7s z^D{O4)m2a`{k(TZ7Br=RTXPiL0U@5U9|BcWHiW?34rj<2IaC5in*}ln0%rY&lpc2_|mx+Adgs} z0F`%5a0(Ns{ZwE z@CPxfcXf4{r}Kb9N|IDJ>EMmCxM5O#$^kiu?e!y1wbhW>B3N8UfuoHy}w0_H?EL44| zH!`^Clv<}%5X7aOulorrPFXxwyCX6z`L#T_v9LKlv443vNnp!vQZ=DO{;!aGD>3tV z!L0`5JYhH--E(YIWjz9BnE87G)HqjlDI4jXE<*C~c4;t-CQ^N?FDDG?oOf9x9@k2; zpMYk3?eeIWj6)k;ak$c=h!&|A78x|NUv9mym5TL`q^Kaa}mR+ zg6hA&BPw00(k*R1=TB_rco``+egW1R1w_OG;8~Yi*~wE43!S5bF0_7-5Jt;gse3wb zSU=i6lB4|M@oIT$OFj5?=Bi*re|eInV`<_tJvnvJjgP)iK*V#mEbSXb_gY46myKWv zopu0Z@AT1qNoVKm82*thj2!hSm=hLC-0AgQ11LH7{+#;X!#xk%ndb?W!0|p~ zC6hnKb^83tgVc4on)dYMnEw1=9uT)M`zRwOB7ar<{~EY^ZvYS@ZB`!|0 zBSi-2Em>fQBpeb<^pjG^%mgFKKV&8x_pP1Ko6Mev5Acf*>C2bBZ62AMcp_I520XnD zAcx#}ESm%(S5;7Vsd&t@B5co#xsuWw^YVA}Y-lhBb@G!R4Tl~GJ#MqK*=!B_Te(3Ly88pdw*M`UNRx5ZdZ+Y5W1K0qy4Xm z+L1Ag#$f5ijXijpl1}VuC~TqoGx{v@;Opsq{K6z^yV`ML2I}jn_Y~u^a?{U4#KfcA zs}!rOE(VOV?&Z(3A0NtwCGl0D7B0dyc3XXgW;d_wFHmB(wpsu95zxPMQeSpy=q(39 zXceF^ktw*H_es0=EvX@B!k}Qi6)CHsXu*KnB3O|UCK4=xh&VT`rl}bRR@iFSFz~0v zts~e#L)*n69z0b$wlkMu7pT*A-hL)-E>lQgDaD0e)9bhuzd-NC;+Ls~We4X*6C|sM zr!whN#yHm}g_NHVTlW_X--q)u5#i80O3;F|Ql>{j` zUUgblYqmE_Ir*?oytSX@WIX2yV!g;0wmJW14ATOWb{gI-%HP(19uKIr0oUi$b6hWO z*&9iI<58iP0H>1V2Bw|cquAM8@c=Nk-~v&-COIUY2SzFaQlk}BezRrpugUY!Cn-Lb z^bdfB1P*|v2JC1a)3vR6EX(~%w(*2Nt~MM2f({&tk+9N>p|%6% z>i|m6ghh#kUN{X?0}QnUA}fIP^pLL5UYzcnIxYfIzQO$fPbRLr0%qZO2B?ajn0r?B z`VhK_RJPg4%*al|nkB$c)eNZGX!V2G8ER~rl-be5364opsxP9}K>JaK%U*;=VSx0_ zXQCx*?!D|t2lX?|lII??|0VW}O(c3>1TQVyl8h<~7R2Xt!kJd)=qzh(Lt1QO2z+GX z2~m-ti>waL_F^jhcSB4K;V6TlJ)}ja%Cqy;z{bm-^A+LFtib6wTfCle0w%_N0x3siUycwl81Jy;M)h?%5cx^Nf5F_lm{9|`l z#iWcJ;W-yr;mU!5Zy0MzCP+GL2ljorbFPtKP2Az}hGhnS7BMNyWImys8B=N=+#(sA zot%S#_Ers&Jy%#+iW^Fhmm_vYCG5oY9-DcOY+R1i8Kx?-lCpXTD>!;Z1FNvRB6)_^ zylWMdusY8o4i9j*!SsM(D7t;aA*2teTvS77WwG6*3E&#H=97lctA1!p%OzfJO_1$G_p3Pfa}dtw&K8YB8f4-FW)aIRx9-f_AoVDp^Q0vK7p6q zK{qdqKDQdZl1UthRvk;JSF@{l;;blmd*iW>L%Uq}_R5r1 zoWmWR6P`#Dr62G3@D?w|K6#0|8kN^GR1zBa33gs;Fsxtv`3chg{t12Vg}COd3REy4 z;It>c_yj2b4yME0dFp1q90pg1O|h+%u7jf;-V3!^ORVv}mT|!MRwi_IEWDBo%k3kt z)l9FVNwIAXx0L$uEvrB`+%Ru~eVJP*4(j_ssX$En7%i~rYhW(xP(FkHr@`~3v<9`X zLR3wtGl1{I`k1KxgHUF#UmTws-oGKY9TGr&hzvj^a(|9MU)li6IMQ1IImKh@zQQ%< z20Ut}A7Wf!kiZ7H$>Ts@HP~eB3@ACmcDNzmmKGT`-WB`?Rf4RtIyvNZ_qiUIafStv zUv2V$qMGq-4?>ip_T|03Qc`Y4bB+ZdJeInPVhRy*4YTBKTXdjgm1)LR?7b6(?yC-? z`~dv0g+PZUl@FoOSNL#7&Uea&xpe*ex+|s@a71@?311VS-SLJt{8oI8d-Z3toiBT7 zK7E2L-Q9?RJxWR=nNoM`+dIFVt;S1W$Q?hzs)}hakHZU&JSJY zS|^g_d!ST2cV9VIQY@ji)p)XJ&t(eoYTGsl1;;h<@u7_+vmH1l18w;~dvh)bgeyZzSD&&*ZLd=3uSTv25uy(#KnE&b=v^1$hWk0%}Y?9^5xV zw1>Iaz8qJF z3=)sWqe%;EdPr?e4I`gy#g>uk&rjZGZ7nV1xGV#{Y-g8SjI5iKVIo!YFYulss7I3?al&xryppQL zPAy0SnlvJkfR^qD<;A=KImlY#Mny6Mhj2YJf*Mc5a@#oG?rhzD!sb_F7=}@OC7?~1 z2Xl?&Ravi%l!HiZz{2A7lJt4JKNS=g!J6|4A-LK842lEmO9@FL6S$*4PvxWnkd2|f zHT0Hf{aA!4NGCswzWtsssG6>IOX`$ERa3PMz*#Ic$*<2|FP3KjzRs6L@7pLw^ka%7 zsZvi2&zH$rQiP3haHN$x$^G!Tyql;0e*lp{Zol{**xXv3pXjM|qhyG05!8#1gcs*$ zTS=WDv8t)d)HuxEt;|(V-F5!fu$sT^_-*SQ&uE%@%zaRHA5-_;Qj|t~y`~_YM2e)4 z`7{U!x4D0>rD%Qb>nURSZ6qjd${T5vPMZVn5K5_0(@>*cLej8l{QxD~v_6P5y7Dc< z(};;6z{ygkfx*IBXnHKc$|BRm&|@t+2A(qtIX#UG-NR9)m4{&2rpzgUBPlNW_4K#m32?5JsNeO{%4gLjDpjd<9vEr+P zz;GG3%7B`%f@vy!1Kv}(-RIIM4z{oJ?XeA?2Q}Kw?d{F!^}m0*OQ&ZaKHNXtoL>F> zkB9mFpMUu9ubb1?_aDE%`}n3HDwMaUKc4<{dj6))Z*ETC-MxQEZy+nfe(IL%;;b3= zNZNlqyr~RC+FCNVg2Gt40QI4#FUd9%PI>$VWXZqLw^7{x=AzJA&wu>Cw_9 zGsMANGPx))Qux>a;a@-#KC&WWteTKsvetitFq~P5e3d($|4d8qmg6W4XI3IRWkFm$ zvr21zYjW5{e7DPjYJ?MaA{S+bCg&OmFDXM!t|5m*lbVKY`D zqk#~>;7hDTbO#nc7DF=_`2wLkY|;+4g(F<+qbbPMQTql4-P1YG7!=_;CJiPAi>!aG zA7u(Cy)!{GGAe7~tethTAwa}Y##o{hf>ZZPphQ)ZyKJPbx__X=ms#zc~sXr~rMw2rKK7zlq9wNY7UBWz?<{6C zDe8z(2nzI+I0nS(8|aYp93h;21JN?uMh)Y8T4OjeB($%JKm}SBl>2Cw-H?B@w#r)f z{dwt9G6zE|FI{WaO%QE=|Mb$bq0c`%s8?jp*hpO7_hdw%+eCmGEa)Q{s=F~bQbO`P z3WSDb4)ly^V<2ygp5e3rg#@~lyLPn(_{hl-s@Pod#b6XP8-`lDZlw*6{b^}T8zUZR zX-FIGC=iOub}(-S@+aIAT{wS&rlHm@+75~l=ZI~>;CPAHhT_tq9~2|b!IEw|`XyNM z=VKGZ7hr@AL};-KBg#O;j$?xa{WMV5u0evKJYpOK0)8nRh_U-8KM^cA?p5Tj-ZwPS z_N=n|5+oEI7SA;_mMEd<#6&hU(aQebp-5gG$!qlvMe=HK42DNuB6oj8=r_66E5G+B_lR&}CmKifeN+G2`| zj>iI~XiJS<(eb!%q^^HGrpDVTU$jLvT3qQ~=+kH&W3*m-K&KI{o!;e^0&g;5-Ln z&4-_V{PFF&@ejW|eEaI*-NW7O?dkP*FDt&hf0yd%`Lk5N!k?Sdi~A1`^NBCme@k6t zzF^SmWq!k5FF)SDe{~1&>GblO7wPo+?w5!3_P_P<5-@L0&mr&b!^0<@uPZ;#*Zy?> z^T+phpO*9b`Lln&+2%vt-NW^iaa@3EXG=vSwvpVOkt|2Hk9d`=4~zkwFrS6Z}n z(bq++i*a5=Sr>I($huhR6}B!`$+1d~RdTG7W0gEs$zy+&JXXnLl{{9-W0gEs$zzo~ zR>@=R$#UiS2*9@1v&_B?EY~&}S8Rjjd(J-*Wu2E$&KRt)jT_f7?0HCHyvNY$1q2Vy znqCLdcRip$1{A-5KsPP&1Z(s?C&5Na{K_1Tpz{Q4^s(o$oqz(oT2`0pgtfcDI>rIZ zK}9NyFkXLs%e;VQs8NdW0$f9_cF=*kHAj(d7Z5$ztXv1-J053CLHpWza#W>W(8O{0 zg@Eg*RJIx?+0htq0)(Xt1oUv|pszyMGeC$flzhbCo_THcDux~7gLvRsalz2hK)^Sz zVes(<=zy<*g!M=VsadwVSl#vh6UYAwhp;S#-K&3Q=M*^LD4XZ%dy*3EYD0oH<(b5C zHI8{~MvkpEc25vmG(!O^2Ca@XCf708p0tb(40v%KcA?+Bt~=9s6L90X!;pw;Hh z%qYvnL`7kyP4S$APEpx3)Z%l_sPkI-oM-?Hs)@RFTxI*tKTL??md32!}* z9S{(&ZbS>8`5$GjZ&db1zuNd8rp}uamqAGs6qga05flS5HZqq1<^m~ywOLJb+c*-v z=U3=RRjoMqCYhVC`9arp~)K)SFnu0Ct@WVq=$#{PKcB4U2qA5F@t-Y848UQK0 z*WC~8pKd;0@x^`jiY@LJY;p1Ad3y8er?*BdIEyou@x{&EA`y#(WieCGTQ5FGpLz1z z^0%A!yETi?E6rGR;hH6X*U{Id&{1C3Zn@$akIr0CG=1;>wp#vRIT~!eI(PrZXAG02icXh2Dz}yvR83RUf-bKfN>|^9mwm4bu zW*Pk9uXzd$Aq-Es3Rc0G_OE`$VI5nv_X}!#^ax1<8|VYvcKEF%7jdSO#Y%`+b2H$a z&fe#mzj=#KG-h5x9|l@is)vUvIveA4*hX3m+p(y>}yMNcyy89!s?RD*L_p= ze}&clm~r$ytl;ezX;futT-N}2zp-IDVgis;=dNiB+fn-w-m^Z6^9ZI? zBD!m>rIxL2yX0wf@BBV6^3C-dYQamxB>atk_7)hqUUiRuT@NUN0l2!(A9{x#K-{D0 z<0s;)@Dr(7*?!ZkXZZrZK9)%`FyK9I8Ph7{O=u#0Li2Q%MnF1~j5NZ-SSiJ0qtxMX zaKVvXTzh&+lNh9zG^yUv3mE)7y%KhWUc>nxvMZZs7kao6(T5zuiEokrLE|!*uJCB{ zwguNK%Ladcf0jk(U6DWdL&hnH=V}M#BMnxrb`=DUeBMKoEY5akb=5AFj+!F8@*jC$ zhUQ6;uS4^?aG~|j>yx?j=Wu3*@qIsr$r<`E6O24rXe02f2^^WoI8$N@jy7g=bMX=m z{CjZF0SCcmad>CTYTIMbG|@%7y{*2;M3p6+sP;^M6iUG%*|mdkil>hAy0Sr@eha<6 z-4^|}rO<042$pr{F!**jkVLK~LzNe8Q#GY6wq@Ri#onp9*YKiLMrTb8Zd2vB7`B`G zboeP>7?Vu{!TWv|U?pQF^bTP1B0SQMmhx7jqA+qk2c}jrH*yk_wLmPThf<`OL?lJV z2DGk!?E^Jn#0tP)v0r_h16$TpN%t?L?4<0K}M4;Ek!?^?h~yaUeV)(9u)Ve4Y*Rn zRSzu*2+t=R!gzZues?x+iw#9p$R4ov!L~hr1#Rdzck~=-C0Mi?QZ(8?Ew~CS_>uDg zLCaW4eGr11ZHojvc*R*$J#67P{2NZ(+UFD)zZ@Bj-8XhcE5cfkD!lAx>SQQ{7k9zxEQ?4nwYcZe>E%4voJ(QMuqdMn%e(z1A z<701h{3EO&gxL#M8RtOvgzRK}bGOTbGXC;(W5DvPCml>f)v zuYeUvq9?gO9Z8e@C~0N|m{7B%`4{{cMAKP3I|IqLwcUe<-Iyt*zRkMg|;N z5FE2~;1IC6;s2v@P}3+5K|$+(WET`J^T(aiWra*QJxTy(@VyPNsj*q)Or zp`z2gT?c1Y;LJ};K1xWE0%1mwlq$M(#RkQp?>x!;8T3D)+=TuL{170sVc~=}Mkmq9 zu^T|=D+A@@u0k^n8X<>&>=kwTZJpl^e0h3p+>z{vfXE=ao9~JY|DAS#82lQph=$2A z{HHHbBs*5#fv8~8CxULijCbXWZt+mAbD(T}?Bupra}`5+@;(PfzNgc<^V+4&vr2lqQsIB;ZI(ON3OZHo|p5MZ?z6ksbF9|X|* zk8295`LHzFM_j^vri8D;a)Q51fc^H7o}=8rS>L?sDSyX@ZNt=;HK#FvfqYWffweR5>(O=ATY%?YIQCA#-Mqbn841fdp$fdUnOmKtt)F!;XN)YN(trkz13 zg?YYcnMS_^t1qnL%57(9#5*!PXEHciZ@VGJ1ZwzQ8rlR!2aN=)+>HnwR)${^at^CdyJT+3;=PhU&8F8PwH(&IIezf|f=(_?_@EH>G+qA%xb zeJ7CMZK<fhr-eK*oLA0H`z+u6tQ@(RxVk>9>OABuxHw$wd}H`b7;0H?XHMdw&~W zi}i3O=_upC;6a4303uG^Q-@&KbHJlWl9xZD0P}vn2+Sc!s)YYPp*{%GO!y$}foGD9 zz`s6#p6s)i@b8aSopE=dWgX-eq(E&l2y=uVUEV%<-_oW%OR^aH2l^zkfFUr z!`gh~)>}MVrlU)m@%OIGt1#i`GT(M&y)HJ8MD4INq<_7i0&sOm0m7*0dMqO!QGKmN zmescMG?QG0Bq6aX*jq=bLr@xrQMk|U{&9!>gG?azY6aNar<))6hE*;~A`;6^D_3LW z3uW+7!~O7s*;IAp_xPdnkw&u^C_fe+n(ITBQOa;lIZL=SiA5@(qz!-fp#L^l(3MJ> z^!x7}nVct@QGf%)mz2c`JgHW}4*$V;e)H--fP$K=mqAGs6ah4r?-Uic0;LmzP69MI zmjUk-6StZ36TDTI!N~y=w`fTeWGI(GR}mAp-*FV^90D~omjUk-6t~@u6hR#UHJ0xb z6}L336ki(xH8__6?-UfbsmBynCjvGww*l`ITQHaGq!Sjmavv4T43~uS6BV~oEEVVo zmsLp=6}L|{71aut%yASJw>m%-{~eddjuaM`PhJ%c12r-*m$Bj%6aqLhmq8~JDwm*M z6$pO>*8~Uzr;y<8?(XhR6;MbOQaA(+8r(_n1b0aSDcphuf)m``9Rggs`<~P9^to^B zAA7AizcoKubC0oKQ)}w5NdckOAbBVR#>U0YDGX2tJ6n6W>sUcl*|b4+9)Ks1&kFPP zYh5tR3G`p|6CvXUvVwu35LqkO6R&IU0Z@OlaszO40=PJZIR%CJxSrOWJpT%Wx(Nd` z-N4RJUw|eE26A%(L!KyEsEvm+2m;gbaB*=0gMiu~cc_P(4ai*>VEa_re`f{AKwW&? zz;^a90HdC^0TT-g>)!~MkdP3-+UH*kKo;Zl1U*dOfz80}#&7hw(#7h5aP6UOdt%MJm-IGCOam4g6fpw52?xMTh?Gg+`3 z$mXdjAC7;{%@G3ig82OxYzu|}|7;29;liN@0lRvDlw|)m_zA-N8?yt!0DPR>oI;%3 z0FWyHQ>Gm0EeQQoQ9Ml%RhVnca*d=^huJ9OMn-^#x2PAUL2RJ_p}z`$n%KXJ_XN4QKe-UV_@`l+0RO3^4uyejKmf+SO=8N)$NA)srx(}% zX`cV!|4$43Gl#r~lhdF5Gyc^$;Hh(WfGXgR-kq%6{wv(d8SLcqe;oK{paJMFpZ|Y! zlwej)U>hljozuU^1a_APdxL*~nqZiX{a?oT3)h1H|NP=WnoxJ}AKxs1jf;=#ADpf| z*v1h8a(91n-=7o+0{llxIfxAu2!_}JbYM^ZvvLFe8~B5^@o;l{8qc2>^mO)Ldt2~R zfgq4K$OdzE3Th(~=1>;~zpjxY^J3fh!PCXBclqc+#fus1gt*53tW$rT*s+w1H~&H~ zHCtA5&|bXC1W64EF+71xE>^(HQAoOl9Sxu0E&embDAIlQdQo*@>|=Ds(G$)t(!_Vf z>A5>HKD~-Z)a92(uf=7C@pZzXgn<;-##`I28mMHH<%N|P8rxG$LPWPAhZ>4bZ?uF_ zC;D4uIUPbG(y^4=KL3BbVNf>4`n-QdP}zcSIXTrWjl&l>5w3srk!(e5XZ;kN$FOzAF@*K7+|N9LjY^!HNU?y8OH4cx%%|!sGHZiQmNi+>-SU&M zA6sySO$uVUXI$F;KU7a={J| zl=m(Y3A=zn9pPhjGBNMgLzQ@EAiq<&LCWj+$Zo9AATock1LmlhK8e~aLX`_o{2Crh z<#XQ>>kKjVA$25uhT5e2rB;vnD`)Wt7uE&rZk=F=WHGbdC3;;48ijoszmo+0C9&$D zMZ@zk)P<3>x0x>!n_gK4*@@vsPw(M>=cvNPjYIP>HV=ML9U(>PkQdcZGJ5adUW1KU zgt#R&iXMNp8YO++Dx-|`fBPW*O$z}uM&dTXvRri?9IfS zeA$HcO|^?iKE4fJzCwpd4q8V}O<%;eV%T#c8q>GJwjb2zYxv+k$id?dif+O<>rK>; z-ws&pM&e&qE|>aT1AwSS@@tZ!>EvJ+DeJSd%MyR=pX*E&SIkv(@n2nzey*F%8RafQ_AA>{50hqOm;3v%f@0dKpZ9{4rQ z+7+^q@N8G5xO-bdBh4X^MX?!$|3F=MHo_d}2kB;;&V0PH$f}~l@Iv-YbCOIM*Yvz- zCAF4ic=75^(nMAg8v;Xbx!bO*{~&74=y89|Tp90c^5~TEG1PBWXxv-}MW1}v=V?Ee zQFKzwTE(vh&=X7>lNCX@UWl1?>Z^Q3v3tHUlTAj^fN^J6c-KcO<}?8lZ7$6*ieanr zfd<3*^VxfXBELTOTgcnE4~_Wbd=;+jPO@#2Y}xox4z)gJ3qR z5xqQh=vvKFTs|2H+t(5~!sfew6%@pS^sLigjZ7244$X?t&QwV<#FC#h?#yNcpd{`MKwkhHpntJ)VnSYi*<1Q-2 zAO{nUF7G^55R+PjmyRHNJoR{!_mhX%O!j7yVlb=Fw3(g8>jS~OQi`diwn)1W3kp`M zWJ~cniB#e58V+<+T-N@mW^sZh!}cZP>ck72EXQ&OL53_@rn=+=BP~8tHD!MdP#dXR zs@FTtKD1M*Oi!OamrgYMJR1uc!h%iYVx!=oKBL@uU(t)t)%080$3RjXP4e=L+6~j0 znE>ROA1Ji8cR(r431#Q=mnLfz!+Te%8Wz$bxu_=gFLpT7=cNUEf8Sfv`XDj07Hs@3 z)_A577Auj-t6e>$o5L5!(%66UQevs=VDr1cu4OcxAxXH#sNu?9({AnnnYLbVwu1L6 zrpk9+3)5T~fh9ab0fn#ja37OaBqiMBMqU?nd1lr0#fjGD1H)`go>B+HR>3M`^MGt4 z?dmvJ;br+YFYMRF-fukBWG{-Nczyv-?_}MgbbqeRtUHs%OtbYqdLe&$ztJ1lf3x}k z)^cU#Q=$AEh>$&Advf-pYaLRWp>GWvoR(SA9CpHWlI6%q)J{A+ttX1p)y;d=D;+ZF zr=F!_ooGK3$g)gt%dkl`iPf~}*1>m}FxOMT@Bcu0P(_#i?N)1{f3~5n%q95(ZWGr; zHau^@1P)hxe&4Cs5F~%>c=eo8JpBa0m8@k@015f!clOfK(x zo*3j3A7GI?x4uyc)z|yZYiv&{#$4ePuQBF-+fdt)WjFjPX_v0(SLipmHfF7K<7&)Q zE0er?E5aT|R|&FUg_Cez-RX0T7QQ!FsOiqT#Sx=r^8;wn<=TH=_bht>wu$TT^^Coz ze<Bx2Yhc_ha*T=xoKEBC-Ayj_#%qZwCvPa5Z312K) zKePAzSa4tV-DrPHhL-C)fzI1vCJf8@cxk3>m4teI)uG8kze9)mSnifra_zI*#cH4D zQJK|0diY`AWqmR*b$Oq`FhTBhgJ45fXSkHrvBM2-o!`*ml*Y1Jznl!}Srb~9e?khNrwJV5en8d-v4zu3#^+jSj| zdPB%d@At0$WGjhkSc;x_auac?#_k&*?zT-#38vp}i;gAP?4M?;N_ULZp;?{Ln~jD`J>mJlyy-9#XK{H?4%9=pJTQTRz= zAqCd6#Q5m=-&LNnRVBn6gz(wz&S-kvMdwZ@ooIh69{;HF`yzy!cGDzWPvqFp{pl!) z;~$JrBO&$gFyoK7v-aF8%Nsm{5!E|-oSDZE1x)OnalrNgK8GS=Tq8^IF}B98Cx>0? z0t>~b`pF`DEDmG1^ql0oVsjt!B>5BBFWl6huqDCJ&H?93CSBUrag5&H=!St$we_95 z`EGv%YIGt<3|Rp=`2uj{@TuJ(Ds)ROvPlMM>zNDHF~KQxDoz%YY|1a>^IB1QSwVT8 zV;MRhZz3O?MS;Vk^{MyJEs$+W?W&Zk%rEh)m06Cl%dsTeiWTU$-=)Ei&`4he!h;Z( z-(4-XH^yP#SR9x#$2D2n#onk>jbNZ>gRy@d3wUS{3ZDPoMmfNL=TfCSvPSPr$w;tm zeIDB%ev+&s`Bt@{gyQr=G=P!n{Z-adkL}jEmnjn|}QYMojc9OTXaqqp`wc zrTP1xKrh+vR)h@)c1Ra5CpX3uTV;+IeVis#9S2gw#u!X5 z4sGdUz!)f&AH18i65#ZO{aCVTo?U+~Ea0$ebm9fWZ43$auuOFQgp|x{-5?wfs*j?j z_783wmt->uh*jaTv9V$qeQhs&$chCoaVCo#HLEDrqjhA}MzLJ!wyHIH2poDrjy|y~ zqO4zLTAuCOM_q_0`Y5}VcMPMmewJCG_=VbSjTMRP(r3J!bC!XSFIRt@Ukd(? zkPHKNzx4!o5Ux7}@{o`q7nut-S0#3=$%LS-jaoS}YWmEmbQ9T7_Ijj`%9C|ko3BQWa}vyGlNYhF@3 zEktvpa3zbQ5lfapBV)_^WH0NujnC6brXuu!sQJzl?|9}GT+!npk;d4s*OIfONwS*) zzqM+sk`(`#t2Kvo8I7O$!_X5ZN84i~O*txD+HyYA<08S48lmMe$`pUjO`LrZe#xoE zeIREn=y%(F6*S2dKkGW?y>1sN)Pka#K@2#V$RRTuL-FbV2AuN$vC5L7XKKzOWrklu z1B0_FhrfWM)m4k=H<`5%*_xN3=|^_H-6#8;a5M96YJ+dUrc3nooSD08C3E?1iiKv% z{-&G)<->L?v95ANm~P&~Tx!k3J+}B+ z3NF9M&x1=p+~~gHl>H`T_hgA{KfDRrxuQTHzhryAWx|FQ|7PO)jkfPF^i7$U#M7?J+l5c%Wa@orE zMurawV!I(RtZm)P=7dkJX%Hs_mb{|AGPxX9giaPCBCjC*wmR?nFNRG zS1zB$8ENiiQ}uri+c1x{V`i_aj*$AScYl;Siij;mj;)#UyKu9(EK*1JF3K!DV1bW? zHco<4$8+Z7G;@w~BIX{_Nl{Y6M}DtwIZcdRwXrjwfJm)4℘K zu|*3J)EKa|zbB~rUCn(mnwYI)k7t|Jd*O{f^VB8Sr=Q*cE?^dVl?5ISZG2;TsxTqXiZ&~K_i_Tj^LgoJ+99-XD?tMI9?F?a#aibCLY@D zp*L@*(pDZ){A|Mqpk}sH){PKwjwjKnhM#FSx){M@2 z!>O4E{9p~SBS78~gAb%zFVJD<#m2xA{4F_M%Z+-$&&st2tNK70Didx!YX5XB6lVCR zZ~K3#>mRHPoq@FUngp<-u{5;lk_w08R~+$;O2vG%pci5>jctSu9?$k1y+wqW74vKB zEpxvx`3CXwJ@Bq1HGy&&2zF8kM*B8w@2aj|z!_Q-t}0tC;(`EqgZ z=~CNghKt?06rXQgYg~>+tJ6@nk*s$QtTun#*=Ee~TQPa%yNKG<9Lh+0K0BFdp!x!) zB1!pabZGw-^65QD-rb_6n^)=z*@j=9fYZJ|k6*-Y9d-C4)rLe$pBW}b9~kU1g-NUc zj(l5~JvoaQOjU;y^%5GmHpm9e+j(zH|LwqeWMaQf$!EwpgXg&79^h$6=?#+LY z79Tqmdi&)M{`wk(;|0xUeC4Oi`JvxFp(%70p#>)45D9l>`*{adVzrE*Wv%tmI4X0j zLbKsN(y&|yaFq3uVp-WJHW_NB;qye(=Pydp^$#exnl1YurOwk)l2;EHjZ4VXo)=nl z&-~geSHx^Hv?cn)o}95mPFo3HG}?cw4gS@k$5P+BVbEx*DNd-48-XGCi451)Vbp;{)l z_nyD%-d{$q%D+cGqMOJ*HU*dQg=Nu3@epQ8lzHJI*6%vTinLerjZsF zUbJn-p&37w)h$b=W5JvzYZmLk7C}_u?MP) zGu9Og({@}VpP$OQ3G%BWg=>F#A&Tu;pLOXB?XzHvMbURoFs`*Ei4sUuj|6)o*Q^S-xZPPM|Ss0=r{>=KBVFeYrYT}hbYM4Gv<)y6KsDeQeCfeYcJk7 zm`JQst!x}<#J*5+%NyAf$Qwdf(2n({byU4IN22LODMPl)^N-PHvu2?sWtG30ml3>I zJT~0ITP`!zJz~RCAF#`3ZM`+-BCsmzUr0j5lRVKW_3a7+_L2LOtniPlHXXDC8iz*D zp{^@%?tHMI5QBkNMc#i_8*Msv$hXXXn55;n#?g#=e#4fAj=F`*lIhAL4UwE;DZfD1 z`W|_9PW734vKvjhGccB@>Lx`|Gzm%O@o1k6wE^pWSHRxHty2UV5{{XGU+v4^qN{Ib zHP;C`3yAP?+o_{|{%SA7z_o@G-D%(j;Xe?rY%O;R^Yb|msQG`k%)AfSwK$Q@Se2+q zb;JEw9czTuQSb1LtA{ZFV|kr`Pn%Ksb)3u8>EPyQ$1JvzMNLeAm$>IzF}aK#^#?`D zI}{q?XUn+o^7vO$U7n5+J6=8tO!e(;9CDZPCIV-(gVcVdt;W!;A`Quz?7et(&Mg1T zktw;cICIGtaKL{vt_Cs5T%s$SFMaZ}%f1w)Bsit&B2vmBi*TfCwTsDu5fS3+REO%G z+{cJ?_@~$Odze1S^-IkJO9Zw1FJac=jMWg9Ropu#BIM?LgOQcD9w!Z`9ilQqa6a&d z{r;amFC26oMDkxVk61lO)vX;81XG7F#c(J}1c;Y1ErEX|{qzg;U|e{mVs%IZ&v1h* zSWJ@G^Q7<04!+lrL;ZbQ+*K%B#+!$B%yaB5^|TT^E{`$b?!%=0Wvy=}G7>khbXLh9 z`n^J9Z{R!AUc4!v9md@~HiRY@W@IRStCX%P22v*Az349aaN71RIw|R6(ZHDBEfYmy zqS%^Re8PYBU>%M9dEX+?Krua|VHKY-s;n{vh{2CKO>v5y_wLt;-{IS74(e1_I&q1? zy0W&DwcKsYp*&%cOp~6(ab4l@AwmD(NIttjoom+A4#nqiC4bf{6+gDlE$idp5`a61 zGLZ&q^RjhRm0$E=U&QKner9uWD`6xZP5d48YjA%p${|a=If)fMDhWdE5xG$g?WqZ29PIjWMj60hQeEPwfNc8au?9Pan!fQ}I!E%%=hNE? z_aMYZj`Ne%Xe=^XUUW|Z)v*=P-~m-E((k~~RdN(ze07e22V1T~_pb)dh%Z#q=^QtZ zmr#G5`EAR=)MM41HR3>2A8%ttw_t1@9ekElF9}&54vBXin&k2+9doFJf?oQ|HQz5& z!AUg9%V+^-uVM!+JjMzlxTaLf(h>+|x=B-yvTsu?{EzE;-&?F!WxOyvv$Zo}{NK0?>)__;)qdOWJ?3*(ul5>Bx1ykh;nxl-|o~560l@u~Z7Jk>mDYCmQ z7x4%+CBHq{bhXiiY78i()+}c$FWfRt9)w&TO{81`nVkxaPBM%0+Lk(c`?!mnFE#Ny z%{9O2FVVCc)2THo5|zFhqxe3;^yXwxPUEOnk#DtY)*3R<)K;mDEngKpC5-mIL9c%v zMR%FIiE7QRR$OL5oTRCDJtDTrajWHf-}O;tVH8`xJ+7ARz#(-hjQ~1pL_4{Fe0QG~ zrM=>;PYQn?MmJg^ypb9W$@1+0Tis&0?E#hc1+i+4H$BgfAqN=D)TU&hj`(*iV+5j! zpZB^-gUgRIMrV*XeQ54^DvIC!yRU!wjrU1~zJc-G$67IWvWsqY?mmxmlYz??GHX4K zUl|59eNGFCI)9uQ)rQXi{lxZiLoJ5O<|+dn9h#xYPZ!T{Ag}4$Dk-kGW)(1V zbSToBgOymJTCOB!?FhGtelB2=D;vVA8NN~W4ho7OEc50o?8R5lAisb38sAD>NWCdS zaw%he6&xCoX|Pf|K|f9yJ?QYRHaq!UN=Z@zc}T$L#VVqpre58T8^`O*i+hy2G}+-M zSPYAA!`^RP$hQ%TUe0i`uioWQb2Xo{_H7KuJd(Q)?rWQQ*HnLnuW^J^*`YD_RK$}v zGj}47WbffIrc~mfP6>b0Lg=HRPM{UD*HY4)GmaSQjcYwb>}k3Ho+0)zu^T7nI;$8L zp5soRI_fYq7&V{N^8Rr0B03vw`uqdy3m1!n>O-!LG2SpH#Ynpmz$2C)g^d~K1c-P~ zi0~&YVm=z|W!mO7&#KoFicVKlLSKP*qT~^CpWG8cp^@dWV*7tuv*Bkj!M$<#V);tv zXy2Ml9{V(DrMdq2MMdQ}q2lE4g!7E4ag{H_evk~qT9Rn}G0Ka$yWXLB92vSr#Nd&m z2(lB)YI&D;;g}##a&M|0ya=-85H9C>1Pl#vw|S$DKpmU!%fr$4eLgm@3!RjxviO zM)^FeTJV3My;=f0R%Rv4EA66$NEs~<6;o1iUxy@RjK=%2mSF1h;}Z2kdlom&ElJzT z#p}Rja-;$*k@DawI^oxh7iwq7MX!v&#i>brUgqBVmMlZ>9Tc_AT&Z8L zMSB%QlX0=;rdMpJq~$9Qg!pNi?E%7c2rkB4N9}*#&@EGsN|k1O3p=Kk72utNFh-g9 z2+<%Sld<2Snn@W(`5WM(Q+y#R(c31iM_C%I@Z0p5w2SIMo@euBaQi@W)OO)Ui{ow0 z5)7-HBG&MCA`c~${-!_oBI_ZM#8V!*@ry7#odhps1RQodq1rlCRBgb9!Zh0+ihc3R zwc!?W+GnL2Fd2?>i7>2ookX+tKQveiB$q)+6cm>ptP~cv-+mQ;373<{6c@L3h!vF; zm;de*7Plat6=_75Tptw{m!IMl5CSqZm$Bj%76UamHJ8DW0VjW~wqtZ=UAHD2t5UIf z$F^-76+5|Ot76->ZQFKIv27=nRIIO__wCcC$N9Sdbe|u4jJ+nViEFO8HyM$l3Z0ON zoe@yn&eoZZiJp-gAa7w~}kXCrUNB}=CaG;;y`m9xQ-k%>404V^9QY()*7f!qLf zpb0<}XbfOx1~7kdadE+s0YvQV-5o8=%$)(0Ka|y}XlQ8vQ}T}qz{veSG=DvvEX-^H zbf0Zi>20oMOM0F3QyO)UN?&58ammXLoFz!2bM4>Y#;>jrc)2HO9l zq6OFk9c?U}oc_K8ESvylj)u0*e|z9;2e7a;wstZ3CxO3mQ@ej9WbbJA*TUwn?k||4 zos+YZv7?2(GvIGjMN#p8=jm*2==@J?CyT#ofSu`IOA|X|mw!t7m+mjjU#+vDg{>37 z8R+KxPb_~UAi%`J$==$~{cr5QVD^p{|4PHf$->s`KQo{OI0DTK9Zjr(PELPe{$l^r zo&T&8@V``VXm4-r{x5I4e_8#{94wrjfYzq;a7@g9V;VdEjcsOO3&-%!tVr3K+5wmt z|1CFhvHuU9E70*@4Wj&KW~lxqVQ6A!YwZp&0h)ipG059F{|yPC{J&$F{=bjp{|1Wx zTL}Jdq4)od-2cka|8j}{U+?pOg%)?Qww5=v`8xpr-Z6l`OUBR^@ORGuWC8yy8f!zx z|DTVcjfJ)Q|H5tZ(D?H&HhruNYD6hp@oyUg&WXB(Zbo-9AIi_ z{kMN-|C0Z(H32$WTi62sa{I5g0_d0+8UKq;)!f3^%Jv@;*#4~o+M4{=3jWgdulyOL zB*moFWoZ643-(`zihl>eS=HVCZ*Kpi8aX?Y|9SWaMp)R+4d6+~#LfwzW9DS~d;k6> z#Kp|&{l5wMFCeD>Jj)q6J6gB_wEx!4$n<}&>i@^{pC{e_0wZQ?Y-jS%=%_dw+M4{G zw*M*kM{Vrl==hi9e=UH&RsYBNUvm!xx&e*h)|Tyzd4ep{GSi*wFmp$yM70O{n7~JZ z?MoX~iwgW|?0S9E!gjeT4c=>m>6>P_Kil1x&h0-ArKyj``Y^01dQ*Vc`FP$WRQ-Pi z$Xn!{95hD(40@&C(=XJcJZ~0dcObOb8P$&Vrj(TRO5UOHXF6FNVQ!wN{7762{Ln}r z?Gb#8QyXH@yO5edQ0fZLFUS*5pB^cO#z#kndw)arAL7#F#KMyC7-IS)pA#iHyBj$E zX*B+Xe0Ak;s#?lwRj)x#{PEKR_icaKg^=_iW*3zy{fdRa>`MsrfKhPSC|2g@b!f=9 z80Mk`epz57u+-X*st6VV_-;SFimnG6jirBV4k<};#C5IL> zwL;=eB-I!>kvcMN6TtBGfK-30rVZ9- zUntUz@L7PUv=K6q)poepwO6~lCrykk;QNAr!LO5nCYh2w z8282zP05}skTMxq{uuc@AJ%_lt&0zYMWfo`rY2hL$Wxu&O5Cgt;grnY2=@IX9{fze z;|(juKDn#FkNlL0?;&mxRtO6*!*wXqq6d2e4kQu9-`5dAZf-BnN-p1WO-5E`80O z$)K2;bHzILjp_EAzg(fRHd5lui;S$sjBD`KQy@T5Rj2v8m71k-%iVHa-Bhi%A7!(Y zChdT-Wa?2oGF~*j)ed)20sE`pX7N91|So%RZ`$~dPU?zF;>pl=|wO5Y`3UqnZ zFQSLnthOvp`nGNs7_56yLhg658)p3dmNc;Zmr6y3NQ_^5i~adxw*1wQxS-?mx;baE z!8-T2ZAYTVp?CY`xvL>si}LMMA_xl^eQA2qI-K+v6?C?PJY0WvXC_Rfn;O2`unVhZ zXE)nY1A$wjA1rk;Md#C3{*5OKPkq^HS|%t}jPEi2Jz+%U;8=?4nP4-YhB`4`#D=9l zP7j>)8Z{UoBE{S9r4k4wG;zD+h!qdz9*(MY@zhuzGgMWUJ4IREc5Ks?iPg+Mm^j#Z z3T`($J_KK5Uw?l}Tx2%mPlHn7_BpYjGi_|1dpF2tfP;;PTjJ5qV&kkvvdq@8(Xd%3 zrunQHasYnO9MqeP6cw_6`-7K@yicZF=Ws5!Oyx&D1o^?&hecvoW(}tg=O72hK|;N- zHCFD%m@bRRbnf{KkJN4BwvV&`Y4#>tllZaGrz~vCn=F6Ajbv;%N9n#2G1AV9<$J~@ z89*R7XAnIfhMlESYxNwbkKB;2G$}<*nT{`4S#a#o&#Tb~h*-#zQ%c}Hkpb|Ph0dTW zM{MVh%&?z2-hpczf{1p||41Zy)06%1oo|!X$i_raI(E=qHIQsgIR0XL9^nU>Z1rbn zJ4*U0HxGZ0N%tUi?}V>vj_SDipx+G(c4ZS1q0M3`VYrrY7oa>@FYcY=qxT=Yr~Wb` zL?s%+z*r_ZvN`kQmpXr==66Z9*1Im!m~KAb`~yh6xF;tB zVVa9dBNlYROLR9WM(N+-IzD=*b@Apkc?HRDkhU)nsu}(Vw+sj7m4;aYALhDi%!^iwnp~?yV@lKlIzVhK`!%8 z5Njd_(ssw7F}5z)>64{){PzCS``DD;#lm3>f6fVNJr;exb1aQlm zKB-mBU^9s#wr>)}a0PxzwCUafQ;)`cYkhxVD$|o-k=Q@B2?MBT^L)7^TglHBHto3c zbAm>B5h0L~i5P*2lhq}I-sZzhN-NR5!j;FaHsSN@-lgi!IDyr~|Fb*o(|wdf&c!|X7}kB4+z3sA?K>e&tL;ep_n$Ra;_ZL! z*-ISWbY_rfa~$A;4l&iT#B;kQ>n>mIUFC!;3Orf+u{E5w{IR{^6!H{P@GcW0(eb*8 z%(8W}I{&A70#pA=C|JI2w^TE%y33thtxcmZKC=RvRi#0u5MLtOYv$kXwg$;kNm}$NHcy^ry4qdcgVFSL^O6pAIALsT&ilIo>M_%hmyg`3~4fG%K z@AB)E*-jU{o@OR>-RkA}oJw`9$|rKQZ&F6LdJbyW#KuVwgcTO&;OPj-`$So!J%|Nw z^=mvvmi@edkY83Ik+Oe=c}dZK7D)$g5pP?cuC#B}m84A)pWdfAgd_**()>;-e32Im zpjC;=)>@7i>aH#UF8rlT0+3Gj(x#}<+M0*&VwoD&%?q#>BXrsDaru_(@> z9C{|zupZ~K@X}matTos{jkPKR)xY)`FLN)MCvYTy^!#s&KDa-x&#k*F3f zu}aCtE43V*UdiY7k!PXD#mv^Pikb2F!^c8}Z+Gr7CuL%`9E-{XAEAH348hOuY|gbk z!#L>#Quv-KH!i?7>{9Gz^p!k5Id04VBS750X?0~R6CN>8t>bX6SvAE(^q@ndKl*(1 zoVh|^66{;etLPFjs#ZfXNZ(U%g>(bFY0Ph*?!n8Ab(Lx$!OCWPE6yu=WGq4>B}(;! zGT)?B?Q4gmvyumXo|%aCRj(p{tsrXu&|7w(f$pmL*rRbM4GBU5T2ejLGeVwpKwc}7 z3YWv_k8MW}G7_!j3uai6IXwC)j(qP`)zw(-A?-5kiqg&leVrtE@@`s07>C48I0^Iq zAF5IjzwI=Iee~Cvl^tbtepz79%68J#;QJs0TAa(3mx<{26~qu`9@<2I5Lu@|Uczm5 zmrv!MRxIRG;r2x}LnX}V^0VD1ehRM#Z3FzPsq=-WPU{g6iZr0fb9q8%Ysky%pvicK zZGjPV?3&ROlPZ^eh_%!ur3NhbcJHNAq6PE&$gTeL;gz@Z+6swyfLSne3iae`H2WB0 zE@s-^>g(s-?4CHn-+;q^lahN{UFCZH6e8|tcbEIkD5YIt0ux1})e5+Nc->=bGbrV{ zWjV5(O#CbxHub=2V=C`R?zTC}`mfs3o=4bCip`d7cD7iRPgM=3QyL z6g;z=hK5RPyE{Lk;iKdYHN533tDTg@vm!1Os)J%gZq^8x%n{XpE8TOW3&kRV4h{#x zzMr(<42gT9Q>(-s)?BI!$rh3lECNKjZ!HysWNK1c|7N$wb05N&bT1r%$^(UVVyGiO zT^Svu;~W{24_X@sS{|sY^!_T+H&*R7t&8>6r0*^)XF6@!Gt&Aqrh4&Eu^6BS3)faq zAW!ZQRHj{kJl)BEiOk8bvJWR2`HmNmlzmiTX_Ry%b3?q;`Ld{KlB7?lacQK>(7TP& z*81i>#p8@xtJY+&jHxlN-jkl?-LfjRu8~vd2$d$WDn=f{N57oTi;tiBNh=3(#r?vh5gOx%_G6tBW9lH75q2B!R}*mwk^>wB=5cIM;egD81rfD+%o`O+{R z55vX=FP;T|M@)TxoW!-QQSZ@T8G1h`q-C@{`nt{aDFDwrPzX4KB*kQhtXEu%YNAjNPbBqQG^!Ghzopg^a_5)7aO4OU~nLr356f|FquV&GfZtR5YE! z4t3~vZJS(>P%TK6t%y*uy5vxzYYUV1_a^T~-YXz05M-~#NaJ*Mmm`aJ9Dq!P%LH^)>>>Gk820c0JUN7aK7Yax9F98LE_V@iPbWo%Au^2eXcGGaAVX%xC|E z4k<4A{N5!jERZf84F9>*-Eix|=~--WFQ_?0$b$5(?N)Uho?3JIz(kW#Bl zqi7vG(ciN_n!STUM~^(v5IPCDbY^=X+Rz}1(h@FQQsJ&vJ|LHP5pRjgtE)e1c7B?F zxV{cv9}7o#EpQl_{qm+y?HT0&?rK3-gM0X%0E@mM z-4Z5qH6==piKS-V%J1Cy_9&^ur~)ZVn*0XAuCv%w{FP6C7{A*(y>ZO1$j8v34|D8Y zX4kc3wOS`zws6Pj^8<89*qU0 z!cLO-nj^}jiQwmS4*6GdVc2-)VguuwnT6nZq(3W)i{;cb2W2lfC0(8MbmEY1_Zhzw zoa^I)q|#=iG^T?whnM?SaENKwY@>Cc}aD z(Z?#t6ptFcS#jVeW$U|{n}bU3*&EAB7#_66Ty41YY<&X^h`HxDZ`1+8el>m zO-j(gN()kV7Q!jRCMpthpJKo2O!mHmOH|c%ro46Fd1LFQ=H#S}mnL*&44W0_>Zk5z zCq@mHI$?;&mhV6SBKVSuVfbte$W>`9y-I^7S5Gq z=Ut1wE+o%@Oy1r7z#sQlAR*`zwYt5U(=o-zqiU`&Yirei7q5Dhu`#H8RGRl?B+q*h zIcQETYe79b>w{j3LZlbb8V3_Nzsx!-1mJvCbo79o7$7$+vn6Jka#$4-u(h%Wm)jbO z1Kpc1QkvpM{vnv0JkRc)s=(bF2(z|2!B6Ot=!V%|iNz@WgwnyvzPxzchmyc&C67KHwdxu!mQ&WVTJ~HTR+sE}6r3aroz*A{- zaLgN5dt0T+lv6c4le@1DOb+-@o+dp9O%iYd&xu+_oU;J+c|nE!tixnFJ)#`j^*^G% z?McvoZg=THAt)D;yrO@m@N7krBKvy4YD?ALZIDeNngXUY1co0MT({x!9s)d27%WKvQGLQ6+4 z9w=!Wc$EC{k^iMO-j+Nds7*L!J9Yzq%cTB8K22;LuQs$?B!i>qF1S>@lY+$QHre&^ z{CB@BU}3>LZ7WL!y9_+f#HxQ{gf+vD@s@0IF>odf-Z(K;#Ou7#9cz}D*k(B-7OA{} zzI+kkJCiRS_?MZa?qn6dP!sDS=G56E=M|;QaJt8HV@;u_I=mK0qxjnG??GOF4`bt3 zyCZG>Z(->8NYeF==!9W*G&J2abt`FhuPSnGO1zKBO&ale>f)5`Urr0kMPG)%Zl7%vY|kUTFRT5o|R)IzTrpe0yY$C;pwp zG=^9*Jy9DyjX`+EWh+sCshLS_esNSf12v+X01EKO_bzQ3*ZZSSJ!7pFXT2{pulutX zerKEb0?`A6)3!Ri^QJ-cawkm0n; z@m4Uwta@`Y;CZ6;x*Ug27tcm$+2^$T__00JNu2#Uj_&!shpz5IA}H3z={ITELX1=^{BY_aIh7@RYiWYZ@5R_dNgn2V*ibik5oos&ff!y*l1&bsrB#5;fEi;XG=x9D2l5weeA zj11N@PPx|ygdXd<+aeN`_0Ry*m|V{W@A=L~#7DAP;sca_NPJrqj}~bMLr4r>)&*X# zpN>9`owBRL?jfyR=4x^&%SqD&pmb{=>Y84Hs2LUo(9CO)nxi6vfvZIZmWsefsZamo z#`@FQ%K;RqPQNBC!fa@H<@i@Y%wy+6)VMip*FnEgVFvL5fd|q3$CMpg4M^K16q#|} zb4)iuTXrpfZN@jSOB<3S*i_BA;kM~fi#3|zi-AAtP_Mr_MrbJO<#gOZ04b~3tQ@vN zcc(%by%C3d)*f(bO3f9X_D|jdbyCUhau&8b#-GmZ)-1uuf-X?DET8!!o=8~5y~osb zP}gm7Wn&IBy;!XK@33^N7OC1$*OFl{gU+!088r2ODHeBK2H-BT3N@oQ%*2_glj0j; zjW759L=Dk6`)q0U8tz&C>#*Dr$kIfXQTJ=Q=IAWNUro*6LCj7YrFw}-wM=a^z1-ds z^Sd&wf?L_pbe($WiW*Av&j09=zA~8L~#H#@I z-B88_rP>*UIQDC$@#gd?bq}h45-T?UV~h5M^+$*K_9BUaG^R#7E6Cdnapj@;X>!MZ z(=`pMxwe!;m`ef9`!yhdGD3ZhMDlwupB$R>Hi91LEXJSFc4MM3EAT6e)FF}ZTidpf zkTo0rN1MyziK1^Nm+6VzLWjnV!lZZ`HUhKu*xu?O$IjfkTySC~yPjkHj!!Al#j<8Z zj-zWfYrPN16Ii5(v5Xto2y!4IkYjLvp)b6o&&=y_b;;4MzqUB&$HHGVkKIC6vckgo zdsSBF1AZ@xr`!8yBK-Q&)&F2~9K!VZaZtZ*Ql0$nMZLS!K;1kj;>irx6i=x?K?`~P ztCzgdeh>Qb*OEecM!T5K<0=PEx|#zCWl!c(ds!0Cc^#)hL8_}K8hXI54Ec6zP8(ngA zwMG@AIS`*{$Ev#pI#iPwNi=uS3%^aZ*Az4aL6AUikq>)a5ZbOj8#;z!xS=rSAG00_ zcstBTxLjc<=VQ#SupJ*{(jU`*!3Q@gU+}2LZbG-Z+s~Xrlu6?|hFnSCc@0{|(^EJ! z5jlS)D{#jZ5jM!siKGzEI>4)eG&9-xg&w!jj81=oh7(*l^l6rpDK$&7lN!Y1hP_xiEsctOs2-6t0acAYL6ae`1e`kFFf1 zLOuw+u})Uo9UWMwwJX9?(zcUxMfGl?_AvYV5Vntz4jkS5T+AD5+=KUVdET~c$^4+R zmN{m5i@)=Zk$P`z?#1f07730xEt8>R^uaVK znhQ7(?g}d#Etl6UV2!bujEhw9Siet*we3H$7b9408V4FCVo;Hx5)xFi|@d>4wh~t zK+7W1q2N--AVW1R)iJfyCm#i20xe_^&stRbLJ_WrnT5-Lf)2s)+m-vyi)W$#T$c`P zEeS_5a;w&<2Ki#`ElZ2}Y%g5G2lE}oV~aP^*UX;?f2%$oB74AC4%M%o-!O z${C(I12OQ0X{bNVe(;`1+@B#HLg`B)`Xi+S?YL&e@|)^(zR1L#BFNSBbm&Jcn&@-) zx2Z@pddmZwUCy*J5Npe_WlLB;WZeck8PClg%181w_C|`&>mpU1wv-BqDXeLIl^-vE zP*s~zY2QzX@#m5AD8OUsG4g6p8_o42f&S#a!q zkRFw#tRvwILl4x^D*UGZ;MjQ&R;5Nj<#d|nYU>)rERl(Dy_04P%DJIa#Af&+VQEjB z>|h=@e9~xUX9F_=JsZ~R!X9$&v45X`g>srvcVfyDR-a|t3qCaBu8)s zMnMGz`#6oY2vt#LXRNl#%6;f}%{5;H(G!+|gX_TA)@BT;|hGO_W0VCl!0 z?QyxhF?>Zq>p_kf$Xza*vl=FmUT-=OLMur9%4y{@C9JL0qFVi=$+P_9wJ`$C9e2lC zdL#$vkI{-ZD$s9PHS{Is1fvX4U}}7QnY_F07& zA)^T?TrDrM#a8g}Y;WNrezZ(7&}*C+VWk_+Z7aq}G>+i(Niyx710;=8L z3>lL&g)nxn$rv$~nW2ihV75%tDxYiSL&nZs;hN6v2Lg<%kMj*itF@brM*Oc^p@*J5 z?p#mZb*v5TVUE{X-<|8v0vRJu?tkmB6UydIMs!Tjj$X;EJ9fH%7{(v|*?}>)i}^-d z<%)?9fd;_IkTss42S8(-lTV7G%w+4iTto7Di=iB5nM4&q{+>^k6bQ!KO;H33rXP2BUW)XaZQ&<(96OHPT9ZpwQEf`SKW@LClBY z_m}nlv$LnT;AhO&0N`Ki%|%=He{x&(qwufhSHH*_t-g)Y+jbh3wB`nZg0TwLRNLl->hL;yD0Z8q1Rf8c|0@zW1QeflCZbyB1t>>N?<%uiT zT5tM-DCrhX!TmU>gwE24Ra^VinOMW*#IRRNfa}W?bz_85F8dyuX8p?+Z4q~ED$No^ zF+@sEn$20zL*+C0dDs#SDQAozj*S??i+0g;DhDQKg0I?~t2vd^Hkkghhk!|gwGBzX z469Ns{IqU=1(x+R4%+Zremk;vVm+it#k&UW!5X1pm4<5rY{7D{w-*HMX#3^eq>h)= z;`dmuyXd}@Z;+ZG3q*?sn%YHS@Wze%i8yHUO1iaX zwVqQ*Vk!X7ds>`iKyu6zh`xJf{##|!klyASb+FLyqqOBpy#7B>Rgu!2b@KXwO94IA zBs*{cQ<4O_B0}JlHraC6q83=o7YjKe!=2{alu%)1At(dB7|aF&Sj^(L9QKl|AcHZ9 z7&=LRW5;q}at!23lILGFg#9J?zR96p!gp3r-r35JlhGE=JI#_<*)Uq(drXQnS&-6d ztEOLbs-x6EU0R}ex1{a(4n`2nxS!u4BXb)V(+Xk1Se(9Gq}j=cD}#K);&UhdK#yB< z=QZ3R!gjN{MqFN|`ewO3biz9NbV1Dpf*HMkErLugf5}Jd?@+}HILs7>G3H0?4FgqA z6LqZUgob4m=ZznGnuV9u;I_tBxV!`W4D=uhhr(;Ehr~3q+Y@pU4iO|vaMBh+< zPG>cs0{(2JZ@I6X!k0U?0)}F;7n8Y3yNz7rwT3ssl*{EE3}@=JBkS#}@pjU^UMysF zQUk99;K7AHw=~oIb-LCSONz?L<(O&UTC@&FREW0Vw&{drVnNmVdba2E4V$>oM&`Vc zI9W6vyk3Pke^+{SEQts(@79I3q{ZQXO~~;be2WfpdVQ(9LWO#2q)U3=_nur1l7t`d zINC#RiCl5Zwv;FRBz z`&`~wG_nyHm2BB~^2in}U0Hj%i&ncepKqPlxFr+)zAFBnl=fV8hB0^$cydI47GVK$ zlgjD7tvkPI_iKqN_a!JVvV-uQvf>-L!H~$j2mpkOaXKK^$*|^GQEhv{$a1F+y8aOA z&mWBFulj=t7xzHyyX>;@lsnwyOR7j&oirFhNwqWT(u3ucc5mxw9G_g-hMBN{u9p(K`^_SE3(I;?;RPTHiX-$1)^ z56E(k!dl{UuGCn3dwoUv%6hbQn_UB@=pxulAO5T3a@J$u^CG-6`=1%~uN~%{Eg#Qv zJji+<)@x*6#uF41qtus;uJ{o20D{U4gMp9V3odAZNcWeC!8d9O+0xK|o=WwWA!9bP z9H^1ZNz+O@8vCM~wyNXJ>FX_MlWjMknC5@f;_ok@bjgd!uPhJ~c(P8P*z0rOCLMwE z+NL3}QUhy*Kge!>nzpwA#qZ_C+?tjgneuy5pGsc!TR=a*G1?+&O#g}9F8!w9741zC z^y}bklZYsni*DomcV(o1`uk}$Uaxr=F`k)qlvcLUP@8n1SDKh!5pobwpOq0Y zjiL;w+)Q)=?YB2+j8$DC>oE&uo{6v=akzG7CLtTHfE!tH2{ZC z`Lxo7BD(KT_h*+OR?z5BDCfJ8YLy*+Hh)waLr5H6&Ia|t@y5wU?!BzvGc?(J7Z^2i zO<*7=exH9x?xh64L1AOf5V|Hy96vjCk8qmKhEHJbcsDnAy}TK`f1*u{zbx1}|13og z>M_nHbmQysqg5||8?|dkn3gRIPD1ogf=SXc4ib-3bv>nA<{#^^*kyt^#pHI$B|_{o z6h)$)Tkxy2$5+?G#}$OQq|Mfx(jv8#3%|Lx?D$D7+O&Ll+4CoA+5kQx)edz~CFv*2 z4FnI+`I$Kh&N!Keb$c771r&Dc;AC%*eNP^Pz0U`^B>R$ia8*vzBmOv@%NvfsU;p_sXMr7p35L@D2*UX}3*fS$pxgq#GBD^35b zJz@Ih*Rhd|>-eJwY+K>=YV+#p(j0$(oH%+=da*|E>^T@gM>Ey74GxIF@Ca$s3;M*7 zyk-%&OWb~c1bWMc2o?K#f(xNR=t3PWJa?X@KGM+Dj?aD8zW;8P35=i0eQ0QF2opRD zB>^roW3ip-TzGU_pS&`*4|~LsJV=s$5~o)zD)m$MgOVB9)(>}BYuU~$iYkn~K|AxJ zgm&)`@-5Ts}>O!lxX4Mh;;Nwi?sl zhK53tWgpy&_fvx&oIoi}`caVrxY-Q175n*+RV=ebF~np{%a--LzMr_SBkYQb#}4kZ zjVC_X$pbUQPDuq*a(>JLf24Z$fDz0q_H(xp{8$3k0v33ZVBlu}VRxf``S9KGRT=!l zp-F0gn_2MHM@!NURG$8hFvoN&wNcXkZTcay8XK66m_-TlzG!KP^Zvv{WcKS1#l^S_ z4aVaMx~w|LD$Y4mQ~|Q3I#9*9f`johnFsD-I)J}sa{h{fs05^E@TGu_>AW*G?3^Kt zPsajnf!hTn+(aa|v@z6eNF3ql<|h(4hD7Iox6`c_ST=(8LAjDDL#WFaBMie5^$8kD zjAFZ0QOTjUwfm2}X%g+zRKg*dZy!weaTF4U$)my>8YJ}Fcg^g?eiAN(8~*hOaV3)4 zW-znWn1G$-{H?a%NBSXF#4OZSZ8{J2LYTGwmM>gJR@C7kOeT%R+77TkOg9?uDNKxi zVT9~-*_{`-49c6lj&uyhnrgTuI9q3oL6cJGg)ka&7LrJwpSL%h)f70XTtL&^?k}>+ z2dsaBD`+juVlm=Es2y0s$sQKqZ&T6{-sIN&+;;1u*<5L<+tm+}~b?OVd7@QT})`s7r!h}=&~5d}X0?#g(bEn$I8DsmNnd6SAZ zf@>lKY`d8v0x=a5%S+mXSORHp0KPDN7q63dYQEYT&Bo=@Ozp+4HAUS+`8Tq?=Gf88 z6kEvL(0rc)s0UObxo*N!QXX7yds5Rt8s^R1UJdH`EuE5eVaP3w=$zoVZPJn)wj|-D zf&lBc)8qH{+iQ)nFS z{dN!n{bxy$t;e2(CkS86nkH>yNsn}x3l7y32!T0*U~5|7O?9i)@tHt`ba?1D&~?%X zSshUHBvLQpSjv}ixH(;3)fL>R76ksdIF9UV@Hw90m*-=*%WbY=^c_-Eoaog*&36 zeid;}P{j_N3({zV2MMk0FJ@*55=#W}8~N8;3NN4&ipNbQnn!Sb!-!7=KlIh%x%MS> z*)Yapt6@>l)6sBSksX)n^{RNST)1;8OVj~;^`7SfQG5iF4cBCUaL~B_EjwK*1wKp> z4gHFNIx8U&WX1B84(N$VBtb<;qH2=M^g9tm!e@1(NTk)vRyF*L4Vv(@v~g%pZPYi= z6({6#QXX= zr%$t*26dt6C)$R8dEJm_b2BV~i8|4giv}J{i4&?UDzlP zsJgkf_}@iVlG?$L)SXpl;Cm?skvi(?=D?+cL(J9DO%#NG;V#9aJ>UY`U$WsvzjjdX z{(hnzgOFBXzvZZO=O9(*K27l~0Lom~+(EE}Gd-@l;1=DUpQ+1jH3K%nK#=L1<|-_!B>mwp&(D;@V;f{P0#{MFVFhM%H-#(zUh@QUCn9kz9AV-C9f2V|9-*$;`gXpWx}Vf@Mqo3ke6u%Me}vM-;3S#qK&^lWINnQl>2lFL*R&o|lC8)pg~6 zj z>LLU#FEWgHKy1fin_ibh%~hB17>-@*JZgC#3>2smizannbHG?hWoe+`Jt-nKaGIX=pPHJ<05rIQKFELtG;A zjkv5S7YQs>J&SwTenx;NJ_+A^0C(BQ$ya7k%j!E~@VXHKIrYJ|>N?)VM*6!CRdg^ zN-e9=HGGl5CN!{*uFy2-ahU!fUv3QtKOG!B(M99Mfg9=6TGyej$VgTo(53FMBdkO>=Z+6E$NbN}-KraBhhq!!yCuF{ZELlNX zQ$&@m1Ci09TH;&l8c2>ymg;y;e)KQZIooUMt=}L@YND7*hyzMQ!Bd8C+X~Tp!U1Wt zICHGK+TK+q46F*Tx>`&b(=Hy^v)c;BP%+-BzhtM&L_dBD8}kO83;@)A_bhiY)O)i} zM~9I0svFPuUO)FPq1Kgujj6d)CEJ(t>fVU|h(kKQQn4Cjg)JsOS6MVp(Je3<)h0mV zs6YYsa!`JAqoU&9MCNj=$D9<1^`WD)07hTev8F_7$lYrTVS1BbOoT7-GJ!0tUg<#v zCR`Xyc+^SiF4(ti^;d*0R1D@>!Xr`Q0TtgqbSx*P|yvm(v|Dsq9wFM?Dk8^<7k_UdUw981ZfDU#WJSS zZ|gFxU^RD6+vehb!R~~gU^3^5`L3ICew1}DZWBfdw4GL3KQU0^ugp}2=<3(YFdpxO zN<7dAig7KtdA|?365~BZ+9b`tow&$jl2A!z&)obm3dPRj;K!1*3W7L_)s`Mdi5@53 zWETo5Ui~m3vUc42o*|P|m*-S7j+Tipqf))PT5$ptntFSGL9gs*?tAD!Z!s|!!j@6r zAGao}OvWw`@+rGXi}C6qJkGACk97GotW!X|U2!_kRIi|;{oazeTIHK%E19b{PXYA78+uiaDGj;PLsk2g^{HZP z@m4v4JBCbu3K&#{l#CzF(DXp)fihRVc;`80hJu(W9y1OU`BV3q%lrXh$^IE}=YRmG z{utIlVap0F?+l{0b0{*O9kszV*7Y|1p#?U7S9cJ zS{=rD#5uO8PD6o&1Uq%lG~$fVs|9lji5rnXlhT6)2f!2UFSnf4d{{|7R)o+IrnUey zi%&RzdPb*n`>$OGxKtrVWiER{mJwkQKMrLXadbauz1zXvx`)b7v-{L)O%BCj2b4%C zNLELc*#-{#OZSnH6_cp>w^L3R^6hMzubbVr-^z!BMmzX>Q*(nbTCO*aM=eOL=~+`e zu;tA!a@pt&3XRof=QSLDqO@wYW-1svxc-=bggvec2PF4&Sz9o}fV`qtdo%p>>z9kb zpKjA;MvW*j6i!c6syr!aq&=5)EW7Sm;TazArf zTK<6_qH~7_G&!9NG^HPLSj#H=v@P+#&DXo}?Pd#ah@#akEMpvgA6fL|Abd`8q=q3S zJ+S3Fwf!xP{;t`dzF<-d#AnHayp9VDmF_qlarZ~}+l#582hHrTPK4DikBL50 zeEPPwsBPu1v!{_ezI^pu9*s8Uu{gpfFNdoS-@QTIIXEj4pr_Ckc?Jm{4ZhA=W;;^g zMJXGov+RU^M*);NBGJGVHANfjmxcoU)%UOMRZ|IDQ^GOKv5V-eJmao^xpovZQgn+} zKF?9;^OIcIjS!Wa6Ic-kdv-p1wMUL@KHG6*On0tj;*)=eKUiyIMtL{%p?l=)*w=vI z&)o5z<5H%Dg6LT6Xt9=DMeRbG!!g=37@U)g{E&1`G7W`a!AeA)2b+nOeWitgvNIBC zoG-@7y3P9k0$vZH@ahbINA;&!)xgsTYs5iL`T|BxX4rpg#VM=mc2hBX3J^&P$u3NV zks)AgazBjv5skV>S`bFnw_I@R%ByfK3_2yUv4U%rp%7OVFV92})^gYkT)4g|HiH8Y zUScW?!GBB&V>cFX0~GcAfnBV)=xFq89%s<8!kM2NZ$KWg*u&s|Jx3`+TtkKYgC2v& zG7&6p)Q}tr*@`R*in9~zNPTLof^+Sn22%au&Jb(cW8JK2EC|?~yuZQfIX9(GxTnC` zT^BDe-sS~@Z_~L8!g|kmbna09rzn1zN^yBXv?_$R2yuoOm%j5H)|22ItjFFK5qQAN z|DrFRxj!+HbW|IE)wpCJAcSByN3&w#zU5+5YV`4uuryY;lEL5H92%j{+rG<FB22+ze}te-Muf0{#Ndh~<(G|ofb@MCi|wqE{%EQ#nI&M|@!R)m48{E+*r>VkVE z%B4no62-i<=)#8p_9pk5A(?JXo|K$T0oZeEX?ve>A>M|6n86(KmQ_{|_*NvSR({Us zSzJ6i93brFCwV2EVRN5a-G=TZu@0sNWAT^$mxmJ0`QRf@Qkvw}mm(=jdrbQ z|NqGbxGZ4zx%k{L_QC=!{=e;J>6fVk*NK3o;;5f!_33%`xIzQpUv2f<#-xi22ho&j znrM6P7e$Bvvq=?Bh4D{iz@@QuTzjxRGutj0H8BLze$5t!9>LkysjO*3E9ze&XF&<sqq@j6HkFph}GJekf6LfK>h~ z@9h8g{u`>``Ng5-#;o*G8YGFa36TT)SPb0w$l-s%J;i8f=@!MZG)V{a^QX9y2dtq! zxrp{%?N+o2hc54!Y2H2aSjXGrJ9{=>6Hzq!XB=Z);;|i{a5y&_JAwXxX>GApsstQO+vm*eb| zl;xC^?)FJCAG;(uA~JQ!>Ln`U$aIfXBdyka7Nsk+O&F-eta#enW(h#(KppB{y<-^8 znrl&Q0y>OKlv#wKjH&f()elGUhgN@_8a%{*_)INJU5J2k3&t#T!@-a$Iy@OQ&aNvu z(XSK4wIy#nKbMm?6RtpQmhxv^0`&BlN?RaPi4j9Dd0I&U+60h zn6-OilqHdRnIUJB^+*SOQOFbaW@z=?O)AYB_d93q6>-CaE-l(;>Xw%^9o=EirSzKN!E5G9x_K*{$oX!S2TMn zrf9O+z&`!axKqV%(5huEFs>5Za2Jk$em9drUQ5pK`!dE1Qgp z_kEL}`OCrBp6|evM-y{pOtx`4j%Mmr57=NoX8J?!*qJvD@c`y8C{SGPPd!!S$w_TwyIw?tF)f-$#pxN z%di^5N0o3nh!XOhb6;Mefd}tCJ$PXSHe_GSh#B@fe-6)%!7T;ut z9D9T;+HPOh3;lyCxEsNf(Yhw)@vJ#HguBh};r`Bt854a8YWyw)_=hz-&5mzObfL0{ zP{fvGR2bZ7n_}}rt&5oN!{uHD*_{TB3f}qYw$|vyCY*s^$Pj(9=z`3Dqk)}lrKOUj zp3wD3&28mHa3+tQXQKM3Y&u(`IKuOSPc+>!)}HkjP4;3KE#9}YzDAxFog(y7bK-bZ zckx6uOUF?442b9p{`B_seQ_5U_RlOIg+@{;5mor=bIIad&(0Ckbrc=|+1xA$bIq>kN zO*`>xs-yQVt*AMj1n4W*mLhKSICw@Hygq_2(2-iZ7E|fF@mBpfDSq%fn05X_7~9)0 zZG3op-@;@N_gHg+Czl6$VlT`4PTwprh|6hIOsAh;{(08F^=GAjZ-UOM3CM>-3#&GW zKaIDu<+rhqu9PA?9c~~RQH8dhOoM5D>zT?iv8m$efWSJ9$Mt+xNQMQjwt6GuGoHmZy#;1RFO`cB%a4E=ADt4!4X0}>3zJP%ApF#9GxVrpjIHvc0=s% ziX4$JDCTIjGQs`v4QEeqPd(UF%Pg?W6h4mk53~Dtv>dNkej#IaJQ`v}F!H|y@+?{Cl6K`+q6D;i*Q6Fi*so;TkcCZ_Prq)gxuw6^>1p)KthUQx^;CnAk z1Kt(V)WSRD8y7%4h~&KOzai?(X9VcxOekU}Jufvz2Tkaz%1X`#UXWl!^^l6=`2GTh zdFpjATb~(!Cs%i1xKw0(f+LSp7ICBw6WunKwdc;46mW+Qz1}C3>MI&PqS9o2QcJ;| zbNQ)Gl-2&M%8lL+V&fBs1ekK24=i-OyY}ZZP0q6K@gCd|QhX-^H#ebTu?M1Ws4hW0 z&92HfLwn+#%C+62;Xg|foJl5QHEUTr!um@fJH@7d@#TitRHb%FjqA)Ki3VKD+4UN7 zWGvJ0{EfK4a0rY6`VtQ1DJtn>%_P~pm{Dg9)tY3QuZ@`IgeoE7-uZk|(iULIa@|aS z12(?H+pAkK9zsSh+LW!z_Uiw6>z)ReFi1)#Co~CAgLT=?_Of8tKdm@bj8(8rT&UM~5Fc*TVWA~{F z!E3Frp1%uabSt>7n3jD#D*b`3}MoI{g5!r4L4{uU@&@R4v5K#t8Xipqv(s)aWFz?%fi%dg)EI*N?i^%T_0zN}gqx+BXIDnZ>6{B&%8 z#Ts+}=8p0~1xa1TqA{!tm{_hdSF}Mod(ZR4>fDh^HmL#p9<*vdG}mS*lM_>Y&(d|2 znC+lCakcFb3kvy$O^kx*B8h*VYd^Oh-+4NRDgtzhB`L1P0KPXivjvnt*? zZn)}6%%W4P2gg`^3LjDbx8B8{kcmbR6kwjMmxQx$y9jp;r=3e0{5`fBAtCkTHxuh@as_Odh9O2pxA$v9-Yc2c^ zZ;1KS5ghX;?`p_569WJfLAw@m)>u+_NQ75Ru+kpf)4I`KqOuln4NDvl_2E+1fAq`x zwDA=AyRo};`FBIFQ7{BR&G=wM@lWY_85LRO>#AI zF(v(`1`%h#?hiW?b#ec_f1>KmYb62SfLo0#Y=}RnAp&X6;o%~2UdHh}R1s1COJ~4> z1i+nIuHcv&AY2_unx45lr_K_8Dw{*F1<6rP`U-6Al`8??GqMqmn_y&_!zecvRh$-z zc_`nfv_HmZ;KR(s`NuX+1h(v>_$rmOqOD`vudbyXAuiYyZauAYe-#0ci>c)u^H8|& zg&;mnHU^rkRim`{6QTqbjPVFOYqx)`p))P`ak-(vN4rLX8>X(@G%3FCpEpaE=01ed z@ASSXwr^{dIB28GPNB5im(gT+1(9%$q;uw%KYlLE)y^tQ!xxB03hzNt8y+^`Qy6t| zk1wfw!!;EQvt7SWfBo0(_rB@<%9n1Ie(fwCZav7O#L_#ph%br`17TsQ^$5gayG??i z1b!DTt!AxMzYw4LpvR5Fv~yK^(4WdPsHfd*Uqgd#hp<>Z1@Bk?nIUrBwN?$U!wxSo zPv;;heHw2O%O}O#4`R2>Q29pidYuYtD4j1kvt)4sc%M=VmqJMt6PGcWgW9*yym6j&0j^I=0oZ z&FSC!&Y3gU`M&vQ=KQhu^{l#A-Bq>jT6H~pQ;;aBG6|GgH7@2th3RZR| zZZ0Ygb_x#Matta!3pZ(3V_U#qj2(`GLev>(>}us;FJ|ltZJ5KvMuKD}aTY zn;VV-AnM@g#sse!kS4$wk+{zXR5LHytmR67iP)jPP10;d=KnE%~r=3wgfPf7p6{?hzKU5%~mT>!3sKu_0yVwnH|W>zka zw#Ht6WB(;{bhi3e8g4FD_7?w{0X@JOXkqMZW(#z2`AhSc`=8VK&pHABTlL0{j<#O^ z@^<*wuK$&Tm8%QT)|?TJh4pVtQ`f(-Ev)R}nEvS(X?t@A01NZK?PhL{|ADy!o&R+} z)c^Dh&EF)9%^d81ZM^_yKyx@I1qau^Apz9?cPcaf_lf-9An|{T!2d1s{=bR)Up4yQ zF7f~Ceg3c15^lD(3dVMS8{pq_2Jm;#7~2E>&KiIm;Gbb*YwQg8XW&?w{(oGJ?W}CQ z{!h;Tb+;z)-&y}p&i@MkJA|;k#b1ROSlAia|82H%k+AZA1ez&Xxtdx6%#CgT9^Sv~ z>h@+pXIm?K;9rsdb-sU{n3?|zreSkQEit

jpO8>vmh})YwnElg7s;IH;{b?_;lIvuoS$;*#0S}B+0H`M$Y#Qrk{|n z?woFa@E(Xh=s!Q)$iCZ?raOq%dC$GD22yvF+yzhTiKMwStXeiQdtVLTTZ;0N0m2DF z-!nLUzf07T#hHfPUZWiJ^FAOm6Qpd>$*5;^xoZVJG_0f|`bscSvt^u1d)^x7Y8q>O zvuxp&Sff^1C(MLbeH3w1Zaxmc!}yVxwd^{7Ih;4s6H8oEFWc8pWG_yYc>MMQDt~Mn z%i~z8*jIi;Z3>1B)i#6z%{wvY^@Q~C+*w4WTGgCM;IwW%pSifgdNt8XXKxjJ9Wl_kC2LQEDa8({>|bgMHP#Fn;%r%Zw5PfnGPqMQC2~9*Ep{ zU<=gmEj(*jq&(VA3O-nF%&e^3A`^838%v!w6`a;xqt zSq!f#e78fD8aXTmPB6c&AihU+cmr{Xb4X#q5OgV4=nl1kG~1EE~V(hE;*^ z^{hzhueeEZa-43rVYxaesK4)j4@T}(JKF;zohWdq;9fv`3~j6iD9w(E*pn-H9z3!I zV2w$dhjzhUbv8g?T&$&MUmGZmn!x*LmWOdfx{?}OcQZU?2?6pQ`3b@2f)FxIKEO~=IIAN_&mZqJ zih`r7vGzl2t^BIpf2;C;63AkWN^c!hg~LC@p;Jt0OpnSju(W6QqKA;{4Vbch*$kK# z=7Fbw@=!?)jZAy5c-ycXKGV++Tl)qGG&F(S0gs&BzmMaBL-2RKXdddln{Xg!dw$4< z^ucrb#$P!|(7A!ceEY|4!h^)RrpiY~_YMm(3Ndc(yaie8gHp7ARh!{-#tPhPQ{6L9 zgGF{Eszm7ozoyzXCSYYUxLnTnmvIr6^q+57y9U!+w49}{(bao=u`B5;>dGrd# z4G;F7y7VcQhmNHu+H%C)%fHp0&z8K&SZ!DK*ht;)NP~YPJ6T<-bh))yXs+arguA4hiFOgzVe?#^2&W3RKcMV?do4k%`e+t10V!qx=( zal8GraSS`6L=xd9+7+6pJ1ak11_wLHdi$QS4wfPq`XuB8V9$oE?WwP+BuXbm;;P6uy0~ zEY`YLIP_gd#TS9IHjN*^#1Bh=+pT!1l9uTHX{l8K+_` z8Ei`Pvje8;x<2Qt!(d9gf_=?0U^%+K(|3y}At>Ev7s9-586Kl&bBROK7cQCV1nWPE zz9uAdc9ApUelH~0!i%|ve#$pBdXx3$|k&nbY zDY~tHrwZ<+=o<ElISUgKZkfxzsSAeN%s?sLR(;f(jL4SB>*vvJ_#H@? zO^IP2eg1kY@tG9$oct==vkT1tu_CGbA$+)hQxds3TxV>!B*TbM6s7E_?9{IYzw03&hVZCntS6F zhj5X50%S#rM}OL;ZP_sU>j$F8-girCYzsH=MI>LwWF?#%+|AY(2m%cW%GDMQEe~3M z&0(|x+A_EqK-vn{5i0H5IHXLMMECf!XKZdMDrgr;5SZMQzM|zFrW9{tD|Jhjj^Z+T ziC%gC~~~d#LD_YH|XQIA&V={CoYPAf?46Lf~ecEcCpr0?sOzNr~HVy%Q`Ol9d$D6 z?f{>SwDPcBfl=>?>CK%VWuh7l>S9keLR(sj^XKayHJFreRXnXW(QTxns;|ezYLL=J zqw5y>yt4(@SLGtMUucF$uSuePVkMLyvfe#K8fpR+Gr|nr6$p=+@z!IlumO^PH+w^d z?V-(l9U(xL#U%Z7_B-Etv;bHdL}nKn$ApR$m+hv5hDinPI<`4Mptl|>W5xba^N3lx zOjmccyQ6QSj*y=!d&Cxf$wdcj!JDU|FGxT)*s6|p&m*GjTh(1ap;S?!koJ7wdl1n? zyM+vI98TvrR^<6i6@_?nn;EQsuK<|T_a-s-HR3L@d_fBfo-ii?NRNrSpwO;g2*D5U z8pz)yfQ%f`xPu!qEg(spZ%PacY;QQU4B!{I3%l1a% z>Ot~R^PIlnyns(s_qBzy(&f6)S1o^vE04?9(d8(u$n%~jv;;dU!_TvS)$A`g3?ECl8Z#@k8LD{yuDm7H{i2JFidLt`wgPL4q0(1-fQ`M?`I(+b<> z-X+=%0`f;dBqhpv$uKzcSh%lIq*F^aQjVi zbH~QO9-je z?fdicHV)#@E6#oke2%Qc5~z4!QJ#4@s@bZ$4nTd>bAW~yx_Cf;GxRuM>A9Wx^>GZE z<}L8eXFV*lM0!*|s{B@L9Sbp42*}yOP+>}y@4=fK;ORX{a0?agT|Crp3-%fOE5C_Qt^kMXVo~hC{J@jR!OFc2( zJN%_GADgSK@Z>CiMCeeZT-+|TDH0&;Bcc{AREoRQg4e03Ux<8DL(p8ioi*x*8u=Jo z!aa22On|UeJbER|O5%Vpvv-9ST*lMRN*HTDSx@nX@g}_M+oZ07S^EorxOaIbmEWOh z)wm-_-w(X|^*5gLA?iofaD&wR7E)pJt4NJu2EQv7eJIU;Zhv2{=e2%@F!(nJ@iDeC zIlTuSZwr)hAq$Ui4-*YUt(r0+;o@v5$n$9>2axy!z8PdyFU=F0p6hR7an-~OJBNW6 zBW@bn+^erZ{*afN-CkB@Mo`KDM!H{=5R8M`qZ#h7E^M4(!aAY0m)p;G;HUK;+|G zqFLoPjtDH{gxud|k498=4l=`Zt=bpLd$Zg{iRFB&-V1Kq^J3BWs_(0XH%Bj*4Blz| zeZ-9VBpt1sZ00+pO4hz1RmT#p-)HTk9t++Wwys5gYI};?%_IFa0l&)?GXa;+MZWPA zCuyF)OhCnb=RE+%9hd)k!0m7{@1&o{6T@9)h#G8s zcnb-Co({PlKcI0BX`lkm%dH@j@nI`O6CTyN4Y?QYv^DJ_u{wE^-g zTtSFai>VcJUyEeyhT(`Q!uybpL8+2*9ml?&R>?VyV^)w&OcCA)0uw5#r%)alIV zcBVk*kX8>pCW|W7)9u-$GAt^P&J1jB23;D~PH2m^xAk256jVHV$a7KKSy?hQ-ALts zr@5Y;(rui)nDZJtgFTp9{Nvdv8CGcH5MKd&xAD?$l?iHz`hXStg*R{6*$Wj$*sCGi zgp1?}`a(bMHDck3L5|Ts#(OFJ++&WjZ;exD+O##Y@hC%xym}+1d5KJgsJgq3>T6lq zXvKx}k!mcdZ}Is=5y^ACS%sWJIz4ND|MBMM;q5P;bXd=9+6)}mmXSFr-r$Nlg-N4Q z+nq_+_mps$6G-FOkgg)4t_JB5jYZQO# zYr8ZVSc9S;V@bvk&+eK_d_;*BTT^j&DD=4l>hq;b6{Yg@ zt_P--UXLmDQC=0CGWM}VnjVok3aARDIA*KdUNw`Z{{cs4(tv4zNB2WK+ykFfz{qYzU zP5aR5w|Upj64KNZQD{O0xZQ;avwKSCKd8DuDp1o{4@|QAJt8g=x9lp96+J+0J}86Q zzC)dhKueyUe5%O@MMH59GXN$y(qZt{UJucK29;3$gL$rxAlgGVr9rpCg0@-T1GJl7 z1S(0f=RSmteLa@=%_n((KustMaj(5&Z~4q71umIm|{U@ z7-zzFD_+Nw7#z^zreSKehB^1$9Y7M~CJ2+#opt235d7;v5!->H@FdCAYM_;SxqRTk z8@<`cF9jcuC!{_eKSpIBV1z^kGH}$iy6x5uss3jUUf7(j)1Y^Mvq(evi@V`d!WUzI zza*25cT9Yr+lIqx?xxRt0#?iXtB*FWWN`smg)PpKnuye`>We#3RWZ%*xpUg3rU}>w z1W2IQb!PorP~Gg_fvB>Be0v-67(gmF&q5Ia1|@#3yUrsq&@HCv0J(~8=Ag)QcIZU5 zl9z5Fv5GmiF+9Y74*O)_#6U}A@y%O3_k^&Be?Hv3VMjL#Lp>3%^1-*BK*cnNIz&g+ zzCq}7qpxexFG6=jIA(`E6&0-OQ#(_9+VtJw9T#wU4M{wiG+X9PM1z=(?V6jikg9ME zl`M)L96!s{{?pPjTREqL&g19vNhxpj(em|;zcJrz!@eAUgk=ou#scI;CaHI%nn-cF zQ4)!a?C!4K!fBI(o@t(5#`MBCwLw7do*XL9M1Fb$x0GId&8;CkDT{7~giZuQyZ7@Vv3oLvq( zZ@`W3<`V=$pC$l^e*T*=qu=G^P~e-SE0kQ*h!oHpKZlCG3N%$#X#w8#as;*tOo8@m^dy2 zW%Z>SeiYYT)4ZBBTgH6V8q_H7@PMI^02cM@LYnye5*98wFb%3tfXb2#rWdDQd>Y1V z9Ijq}`T!%*`!Hb+QF(}|#~_c7QJMS6YYL(94lyf$O0R%g~(SrK#TJ1#Ev z@Cn=_2urkS(OSBUco{T*-}K)IFyUcDL^yS{qYDRgMXK#kp8ILNzE#~(5bPMow%XTz zFEK(Jt@H@L7t2H=g-wI%VKT7xS^?K8_WpnHMH1(H%Jhumlnl;Bnx}k;?e#RiY=|rcWF_(R zzlAc6iL{^1Iq;iM2=ieWE8}ci?-Y9Muz6dZawMT7r2mfZpo6`-`AEx)!aVY|dK~86`Y%BC)#Nq+p&)cwPjan^N zKru{I9rbsiwPyk$tbyq8mL9bW1-zIC@4^+Y*>^@$!g}=aKazC?7*P&B0cBr*E!xC| zO&`g0S1*(9f(L2KcX7x}Pxi!>olEjl7aY?M&FO2q80vYzr##D}u-+nP_=-gg{2S-D zjdH&Z>NFXDJGt}HCc#+q(t#q(eRivb>1i1xFvtOk;8MQ+jU8TKj;c5Q^^Pebd!O8uzR^f)MP5PQl8ulZ5 zoRVO8H?Xg0Wv4moXs{DXAJ&>-gjs?};&~wX*k%Igy(gn<*DqMU+kVo`iO|_>?5v~9 zqmXVM|D%J+KZ<1QLl&+g>M5M02l|6=KeAXYG4i-$r`#Q~0toIt-XDB_nA=_N_pm59 z_EZT7M_(qK46BXZD|1H~voBwkY$zfvZ1K{S_D4eAf7oMqBu}04V-M(|2~{@ertK8l z9z4NvC6?Ir3nWeqd^EFyZ@@wX2s>47li!QPDDc5i{x}sPqUAxo&VsIr)RONCS5`X9 z_=84OqFG13aIB}~$LZUDy1pQUHEhYl-crg0_~WAYA&V|Mf_#oAdOAm*5AhCe7j6tw zZ0QPjS>hR1c}d6>t0&%{VIe_u?Fl!dCS0GjaR~X^n>@>DJ=dp6Ch;G0?iK5J`@-_D z-t#T=V+Ybhbb*Zru~k8%i1L!-_MAI=c7z@ zigCNInO`7TAp@e2!gA6IGopwMQ6f!>k8tIiJMFjifXH%*0b{ig=q)sUF$#PY5ttc7 z&0nq`l$3Zs@|WK<^*_medhdD+PFyo(3`U+ERIq|sw65@rWr;eE$ErdV;*L)ezvWA8 z40xVLt9-l}^xy2-GXwja%&x~Q}@P@S|f>wu#nGhf2HFUw> ztbGf3i;Nvz4mEUFiDhoRkZI&*9tY+GB5DAhnNy?f<9DqzRfdDc>2+x=ytQOq%sOs& zw$5%3QWH%kf7&dpM7tN-l{IYNjn*k*BphCCgrp86-J&#qrZjB%I)=*fe!=jNu5v7~ zyov8UX$7&|b^|EWWC+caKeb~Sh#EXb#qGNb1K&{{ z`_GY`P@YbIzayG25^pgAK)xhqD995`@{ofvFlSSSM8pUemj3XpjzBxML6g>tC>)c1 zjy3xBe$PBnDStB*y(+t_tLaQicW|(a2vEoPiNg~~O3GD=xe$VV{M3tpjJ?cw$da@x zAw>MVQC`&k?C?%pw=UtSWVD&MPMicA+H|#u3nJ8iD{~JY5Bh8zBww78eTe*XbIK{t zprk30WqZz3Q(Bd%D!N)=t`R24N5eTc-s2}%X=6X28kW|m@pIJ#h@gQLV)r)DseQ763Xu!xW;W@hiwK1ea` z`<4oSpGaIyO8*DXMcz%P$`LC{s@A?eI`*oo0G`+jP>DI}e94|!N&M@$E-dJkvA+7t zoWMT&MOC!ms8{yBRsj^eu)ew@^XZYRq!qkEZMq~8@ne((BRnFRoVF{I+V=57h+m)) z7Rty0ENwvu-Zj4dF3TsCE$I<8&W4*}clCmQ@$J8f4Bt*tj#fB%(jO+h>oU3nm&hef z8`doCDQDSjQ0?x8OTqWpABZJ~*Rpz$!w<(|hAU37KG~S0dhA_hbGw4g@zbC}PLj(I z5vVa_>R(6%Xdnl+0-{G+wdn)N19r@yW||h`L9mP{+ukBtnY`-=?^#)4Kv5Y=-3%Rn zgBqbV*#V6h^E;&q3l%hvVf94LGxL1Vu8eRTJ_an>JZhCM_Ie3;W|O^dQqVqP6g|IO zZ|OKk#fQ`+RJ!nOkZ>RyG((L9eyL;Hro|?c80RXY*C-+D_>lbAlPY8huhMu!*w4JE zSH2U6@>Kx}Lm>R#>6box2tI~5BLnkAfhZZBN1C^(ZE;pjCN%}}OhATD5E&!d(Vv^=CyK_LL&toVt4xyckV z$aPzrA$q|pl<2(kH3`_5X;w-~a%|)xkfg~j=fxa!?g5M)+DN6u_PK(DDAjZeMt^qN z#&0@mf{((EYCwJ^mFY+fV&brX7_8vS@?PVsinO}XwPu2fAMRF4G^ zj5Xx-*HrN>68upkQY3UXPDT=cH)Q2m%VEEzky}Au6>ch7Tr)aCtkn>k*nMXkxM=XvV~L=4CnK=OsKl8$DCfG9CEMej-$ z(6AXZcNXn6p*^$8Tp(j@5%9~Lg5Xf6ze;{h>q*KZB(U15h%Ku?73K;phAaqp9 z+D*zju6l>77>o!uYtC3pcK(6?MGk^Xv$eZCL8jSqWrlD1CqIjSgP~5x^OQt%)8ZBSFO?PP(Vt zujlJYS16oz{i!O6r2AbL(=fTw(mo2!QvTzz*K@rikrmmpThegVX z&oZMgGaZ&&)t+K4|8yZ?T6n~u+ku?Sfxh5K+aA5l+(>^X!Y}XNlE12IUIFW8MqdaO+UVWVn#xe#j7@HXd0VG*%!!F)D-Y|E2sP4 z1%@n1Q)f$nJQO=?c*YCaf3P`%>>1fc{AjC&JFa_l{ALEh9oQFsb_B2ujXVjN2bGo4*i$x>S_y9+L z;9^b`k-dH-gIj;{FN-r2F}7akLWUyz!!WJ4c{#GbM~_xk6VV6WfZN($UdO5QkQcCW z_G*6RwbN4wyN2iIT4Go2%fyxA>Dbl?Ky=2|oebVdZcR>*#!|&JYiAwH$j+AWNb0es z!Ya2egO0@-6%6Uz?#~Ci(KXOU+Q;30v{?rn;U;Ne?WyunScteSUZQ3I?aPG4Jtc?E zVSBMidm}6O>amLY{meJ-iQ^fHo3SOih4U_Ox0!6!do3a;PHNMFX(7uP&@%$hiDCBii*s;e!iG5vS!_vNGWXnR0V{h_C*wws zgIF$iBC2Wl@=Yrn8NTS(Lu$Kk((_mA4idhRI{2nRXK%lDc%Wxgkp49SZe$i z>Z=SjZqzr#hk>}AD+QfMpYG;stGp~lu4-w>gp{x%iNX5P^_3oduUx{bMOi%7O2X6G zG7M{wtQ2(qx6XMQ& zuY9neA>`&2k2^Obp_5kaTMNW(!o>oqkP!4SjeA*1eI=Lb356Sf4i;7OQikw=5rAy) zWFLoZrk*r2Cga(*P(!-B&6u(=BI)8231K0j;p{5y_P@Tef$yuc@?s>@UfMH-XPq@q zXsqUwrAA8^UNx0bF`|_bvbAG!^tpfKc2ekdKfy#AfM%r9$`KSs;b#G-9nI_T5Pzv` zYmP%1wNZ$#2-4qwE~+FvI>y!64y4t{=eI53E$9uCOUFq4?w&o>P|+3uud{S3c_vgY z@R7=0^blHQTX-`z)@mco93cbz`}1IeQl|Bu!x*|JVb(_a*bxZVQvu?r?0%SrDOFJB zJ`|exXNb%Rt5G-19|lZ*5zj0k#4Nn5$RYg+dwa;nSXKUiF>E1EK*mb5nEiVdEQ03P z1!GrEVKNz{_0<0r2mZ#)m- zD%8B=TG*Ogw8Hfj3Zu8bkl!<|CKs%0GS-7Xh9jv3!#pGC==Lf!*pHmugE|HH&7-*Q z?7q(l!$r1#No+%T6o5B3)szy2%Gk7xCk?q_#+~q3#2jIRyWRoN_aoCGRfJ^tu3+JT z9ow6Iw~c%SAK|kqP0fYgWeVj0%Sh{n6Uz*DD!|8COk=m^cg8ni)~Z)-KBZJRcQa87 zCEt$jNUqvR41xMG@al-gcPydzdS`YHBQ+|FjGH)rA6|*E8BKOq1Jj@#F}Yts6JdRn zwTN-6xuBM=OXt}Xkb(jg^WgOCs5n$gr1(T=vkltsluLo#2iH}*CE|v?YK5}VD=Zl~ z2p4kbSdCr{u1*{v(P{lU85Bcur zq=K-2k&uAvG4*PuRB~5*J&kL z9nBuMyz1#oIg@~`nU4x{>hkSqHr-W>HYVfS%biQ${QZnxFsz~J@<~)WKCOHLn*9Ck zZIzs%DKY7twbh1)3fmYg$DbLn85A`%;zg$rH)vI-+ctb6o*pYfy8+S+i~?}@$KGXs zNTC!Igdduf#rl&Bj!TwW^W9jP<6WwEC9@9aiMYh*o%1V}-%~j(zp?aIJoIYDyEf*u z{@J;&60K)zD&=z>dBo_3|9O2nUc`tPQGG5vCOAPVBD(T>2};PhrX`Q<>=mDnMSZY; zjEoYUX4lZ}ZJ(fw%O;Y|-va9O)B3A_6rxLVU?EB1&(E383PJj~Dl3yXS zmhM*meuzRr_UY+q|7NHrvf8i0mu1p5Xw9Kw>mHn8ot2oImtO6*VD{%8Wo6l3rxTj! zo5*GG0*>7)H_5$_A%T!YeO!n0Hwh`e5#DxQ^8^@ObnHbin#H995M)ISvO&myZcwJC zbwTi9By`kH|RijIC3nQ1Vb6auo>~#OdTYY!%T-=pfo_RQB3&+;pDB$V(qJ z>pGN5;;vNQVC0vpCFP!@q)_RO<0?hxm4Xe{o3)~w)dYjC?sOf#>hTUZbd6KAwJDVE z0fXL2FTMo=f?{Gf8@dPeE1C{qhlw`cZu_?uK8g+|HWJ-R_Q9$|O- zB>Um?hd4Uu`Kcr9{zlP%b1e19po!RNPJ0MN8_W=nTr4jBv+ZWiAyeuM3-|dIx4VWy zX+bT?k(SZ{rG5>A3Mf2a z@U646!^M3;^8Rl9r!n5UEywwZUDcK0eRSIALE%=mz#P_rmF`G?Ai`9@x5m@HoscvF z$iqZ1}J}jPa48} zz7&NJo#j-lwkyIH%%JMuJ=TH*L+-A=WsqMLh+MKeRWb{7?y-G+R1tax%8n zy(VsTJ!c}D@uM?;L)T!H{RpuaTexKKLvh-gPKNLehyx0LvZKli&L-(7#>n^_^eJ(d z)CUU8fBOrdO@-d6y`?WE-xo&9 zv3;N7%0{J0VT3{zBQK|NNPSf~z*Aj)SOavMgBez`tcO#7@!hAf!spuxlv*oIjJ6zA z{Ag{$99K_DN_#S+SD_%=AiMFkp_Wl?3$G)H%A?CS+J%|YqX5Uj7q=G(Qc9AZ9MY}% z$;ioSQh$~tg}a*dKr@ilVDoB$wnAH*^<9@n)s{TH;La0fgVZP52!F3|6ltzxDi5B8 zTVB#Cw}mc$8iIiJ^HnnC%Ktga%>-#U0~&pBn@We!1S$7AaES39)PAL@Q-4z1!=5?l zu-ns=`~f{+dBmsu-NZQu32F}PPn8~zoJO>rr*8Zxma$03khpA(3#@AvBT5~Z8%|YtA zDrgTGGQky<_iCUek*Q?CyL4g`7Wh%VZ69RkZ?xY?4bM;`9vlH1U=4-79gEt(gFC!X za*wsr37RwteJJ@^MUn3pwNn;tm=4yv8BT;oWJIX;jk^T6cO%l(O0@<*!V~wG2=TvN zkfEV}5*ffm%--Ao+U@KpDT^Y-@^$-_s}Fs1?;FkiD8X9odFK3y5Cl)LeH9lret*8- z)#ZJg#0_0MnZ|EVD)SI$cE2w{Y(k~Hl%SW_!X&suxwB$F84TqXP*H+al)h{}@f=c4 zHvEHsXQE5X3(hT?WsRfgIx0<-Al!Uw!RURV^7ezWZ=a>F68 zCEG0~7DL=z(MUv!yK7}87H$kY#i4)Y+hOzyj-creOqY2-#5kcN`81zg5w;8k2n+#<&`fKS?4(>B^xe{!>z$qNq$?VB&n>(>7R9@tWyUqF z$gh=Os6N|Sr}0_b4leM0(R~+waNjq??-F&V*PQjqM~K3pqG*NV zLPi%UG)EM1nMM{U(O5fOC}{fyJi|$9sqQ@oW|k9tFV!qwm190xMnOM+qCDAVzSvt7 zySpvRk0_A9-5b^zo0p}U`z8YCok}1|=YqHCEZEI(F|@AJQ{s+_tGi-bHFvDksp;?% zcsz4Nw=NYqvJBTFZi2MsTbd~S<|wy%P%@CyviRm@XMxKCeWV}k(?xK!RA(-74_|gg zTJ@rlL??r#S|dUY&T1)t&;p2U$Rgkq=40}#T~$+3yMly#Y&9wy*l@qn>LQkzo;V5< z3iZx8y>#F3IPlBGdm0KFg)e#cLF?YG^tgxE-vFw(!XVSfPrkKJxO9EqQaG&MpPIBc zf`mksUx_H9wt%Nt7?xd{>-9|^sn?V9Hxv#I3!a~mf{`_el>5eibl@RBU+TGR3ae0O z$c*>PMLGivtFX)Pf6IHYF%Uz1ycyo^j5^R>K7`9{P}4VICl1Rb;ZBJWZDiWa{}N^G z8nSWYQl4Os*rSQq+(PSdHmRHmbyyC`&0Z@ZIhvt(MdL=y=p3}Ax0E*Or-|dE$_`@) zn)9Kn__=&H+wQG@XZq=Qv$16O0ubDQ;!}A~k`nMyrQpktivRP4mce3aiP*xG8 zZH4qLTxALvo9+TyZ@BXW=3py&jHR9LxxhVhD~Ip}I^PD)3!pQmx< zQ3&e(k{yVhQ>9mSIjM=9!SP{zs9k>2@5tS4dyl2n0$e*uHP4QrTCgfF~m^KW~^U8dVOI9KONaFr_Aq}?sIM}OV%QmWC3K}h>83xG+(3bhl@(4Em{A(LlO z0JDQ6Tlp}5XQA?y+m-ecPQYkJVtlGrEJJikzs#bljO@#wrg+K{CGi(Co9U@8=SknN z(^tL2mG(F8{re*^iqlujA$qb@6>Jae18T$>Q%7(DFQal|kxe_&*(q;H19-}}Uepu) z*v@MDy@rHuWs29qf!UXgF>E|K<0a5UE~a`br}` zyxEhaDvX^~Hco-=Nel}Qz|Ffd>8Mrc)L!{BNjlWs5h+4>+9Ig}&+(heq7O4rp-*kk zBJgn3_fArt%+e~b4EYQ4y=$sbmCnl77M1L*AReQqa!x|k57)~Ve@z&tO}}EM<9UY+ z>=&|skRM7`$N6g_#5X>qt?fU&x4ze>=finzj`&ombKoP;R*y=mN0aZ}##wh~(0BF^ zR7B@w(U{ZE5#XkXodkvT*|R>-C-#~keXd@yRG<11D)ykzuS+yf9fTqe)%_gB?F^u5 zNk$F?x1E+>Pi{AAK!lw3%96;xns>;wn+bG()EQaFwA>dRAPk?D4&fU@lVh#p=bEwQ zTpjVEnvhh(F#8;2<@i&i_mzPw$_LT{HDeN%(XD28~~1$q-$Z*o$6-r#zP0;AyH_tr`p@O43}gPw7(sY#80 z_KxSoiD6&-J2NeVltA)U5pYsQ9H7itG*A02DdRv4gZBW#k3F5d$gk^J0K;J#Ar!{zBu`ix{#(Z~sbdv3QQnY*`e3@?h%W zVfqPX^t*<#b-Lg}1j)ITkvGQE^2SqtXo^AWPvMLwA^jGmU~Qt)x=NmGIi?x0xrnr0 z?@W2K{`eG-vpuPKdj=9m#I_z7rO=h`_F+yl0&^-w-h^@?EX8T={Yuy$kk)-OBU@w= zb8wVeWi4e;?OAf^0|?dmuT!4`m*|LY+eExlBh|Y@JmC476klo8Jt?69n&Nza<$m&K z&_m}?ATM=by^%L4vmEquOX#lC1)It~#w5zlJTxjD_rCCr7H z)A8sYQgra=K8nCforKx$9t+ujl80T*7hn3M1q?^Q{>Oi!UP;nN;gc)7PawR?u~a96 zD6eu}r040ZilUmWR$`RH>CQIyvJoAK{M}Il>uOoky!bDWtC0hbL0DFsA*WCGMq?2k;lLm&Pg*1X~mQfvUa&Y z+}rH4t^}%w7m>#-<;$6a5^WUDozN7Y!qIo>L(ZFE59nh&Lxg=(bRa>yZEV|`aAI4N zWMbQ#*mlRp#I|kQwylXh;e;pmoOAzm-)=v3)%w1wRsB-Cch$G|Yuom!Xv@_yj9kHK zIew6&8)AF;e#4KyTv|vt+%dpEd1@)Su7k~&rphl`Su1ikNgdfb19`Hz$LGr*-47o! zCi+$`AMzbT(z>e@TNJw!P#vZODyMhyw=mj{4&4ba%Gc5}KbWhC1Zy-2IdG|05AA!G zjzpDA7Rsp=R3(z9Y7zH>vs-ov$&Q$it#_22Z#n57w4U+C#2{Sa_yOVWxEu}GSnF&n zY?>2WslT!YGh;m@uQxK+wDq=gn(nu$c=^8>3_lGDQK-{JhlAzE@a(Vg*5(Nvj)>(O zJZ8JVC0z)!)cyoI`iKVyKNjfX)G;N=$x(8^1*e;w=MxKoZ(!{#xiFspu|ua9dFEIl zo96x)@jb@#GAR)n76t@w9NX~;x1i6&bhFKlId5$p0`BIKUG&LXJr?cBDlvqKu@k7RPN)wd2cU%Lx?Y& zQg`MNAwv$U`~wW{OPh%0+gXY7VQAmpw-jfXg)F(s$h9jn(#Af*}=@&onA(9tl>=8rZ!R>srQiIwVmNnI3o&2)e&Rj*z=%A;*!4 zmxaqb1z*R`I(rj8*ZhJx2^cXZlO5jCcgiN>gofhwQ`yxjEJoc5^dg$bPz^Ni{{qIPR32! z{7m?$*7uLS)@A^8B37+dId!}kj3Jbasd2PX#Go^jjboFfaP@t6eKP0;mAJ8QENgK^ zhwe3CV)fx)*kT143P!=5X#K;W%y%G_Itkmk9t9r`nc`58n=4A0Ivg+=#G;{)X3v2h za4YkJ7f0Ik<{89N!<3J|o+%p`37F{I)40JkBWj033W7ulLi?SJm*GHu1)1#Ej*2HO zv~5X{1MYLojj}r%4T}dkY9HOm#o@4s6ru!H2Ad39<-pg;jx;hLOy~>_TMO~cX-bIt z*w7tuF(~B-MCxWyJJN+RA6$Rk#RfvHrXAuUBny3&7fSi=KVD==jvr;s)to@5 z9OVq>le7osO!2FjBAQOMm|YX}&#atc)>u@1Df{k_`A>=z+;d?Hu&+W*GDN>n7X&X5 zw9Mvv6;mP^7&Z|2Oy)>{5~9fQ2q6X>f-A9%*E~Wx@SUAH%qv*Nau(hXmV16y7Gl;M zB4>q~zFfx-k73QK^fS52mi&HN1mBJWQ-#JQ`Ip`ID;pfMSNa+GqYl1R2 z9pFnh!UH{i&(**eXmNn*nEL||f_kEE|8dk6(2ex(7LS~X%c}Di<$|C272$~jDU$(8 zs--#Bu%tPT789&DPY}0qh%mMS25SH@pRczhvc!U>W=@sff*pVHX_YI3 zt46$RAKf?iIvl$3k=V$IJ9Pqv0pa1ugo3C~kWWGkdCCK^$7csMK2VeVE%QmLpTAH0 z5!aUI5nVmlGY}ZZ#U4p%^|A!UA}0QxlUYgV`DP^F7}zTVL>N>|?%aBl4v(}KfI?=< z-PpUe#&jTZUOV=o3p-b~_mlvM7(~It{x=l7$y`o%IX^;nKD<~eruERMOwPX|(;W=0 z8aFQfBOHDo?IcFR!vPVHgz%JD`=fj@lLw<@F?9W-gs0&%f&2R(mcman6}QKM`|d0q z3})otUN!gt`fN-pVy>-Rt&m)W!(T`alkRa&&VdNC5F~XnN7FRsuA;^5qY=bZDG3Pn zH#IcWJe)5(=4sG-pcrul8b8A~l~tU%e`*$}GFS^DC-V~^>sa;Hi!L6XEP#TvC7qP$ zAjuhlqrdH?`uU{>T8)!5AEFiHPw=V@GE%q(2`G*2=bAT9nBPh3S(Uo=??se7p@Ob#@t+jqI?@*-oq3InXlI|Oon8DcjS;+?DKl# zr;`|QG@awU(fOf7Me6G=U)a&u)(43kgpAzl*C{4~1-i%fgx^`@gd7G9 z8w1;*e*g=8f}e|orZt+k7*e}OG>;>Mu_E^y$U7e2TOU2nh1MY1g*ZL#n@EHnzX_6I z;nP?%he!9(onEzs`3F`=rHzjZodB^cuz{a{tjhbF{dciORWs)z<>bmGV%wBk9)c(3 zuALo>gYpX@o>UF#!+KF3lIiv~ic#=BZxqagfJCRO!nexcv0FR4QTMA=q;HM|r1Kp; zKyAo#^{)ZwBAcxeEpNW(UR-Q$8TBw0rj%XF;8Do!0rGyI0ATvl->epyVavXv4{vgd zLI}=2)`QOkPJ?6GWZL8V0%%%b@K=@Z=90iYdv+h&!~G;RqO`E=16NF-g9Tr-1#$uS z$ny9?UT1!HYnopl&evWY(r0B|P?dKKO!?>zb1Y(KYikgZ)%-SCRL5DFlY`Q&Dn~ zavX6Ar&I;v2`-~+)SSSv8+-S#T+2L7g>MP$b1r1=VvphA8shDrVMKkP)n}}Lr@wpi zF6?q+c*%nwR%Pe|Im4e`{o#g|)yQcqY|RH;EY)YW%mn6z2C=z#a8c#92<&t2 z8{BCN#=!FtcC(S+ElaG}gXTUCnc!{@YnD7w!qL_Oyy9%GTq~F7b@+Iq%$bCz@lNe! zOL7ra6|G1qvTjj4?(-@*WKrvY+c2WiqRs4&jLncp{RMbMedHFcg?^<7|38^$?Dv=1 zXNC#zP*v-S@5F)%N_h=HOcOLEGsG~+m;$Bx4$Y+_Wuw^A^|no@@M&W=$Nafp_XeE{ zj#b9IHlpR)K`|54GE&BL9%Oigg#jOx43y<^2LVAchsSD+-(sI*<^>zzVJI0=&}&I} z(whifF}oJzfIvw_M8z@aZcT=Rw98D1Bd?dX|D`m?8y7kZ>c^iK4hd=&W+fW&*44NA zD|r2^Ksjk?+x(EAiBVE)j}GtTYp2~5J z(dzj{vQF}s?p^C;4?jEuD*`y;YDT}!hpnh^&>f(j+ibN^5TA7t3C8&I?PDV6OB$c9 zuk+Q3{vlYgEE`T2^5gt%+$6IaR%F$%Wcn1tjv|C*w4u;(#^)^3hu6s&U1v;)OR{XZ zq2lm^BRAJmFLaC?Fs#`+Y(D^K^uMJgICdQ699#>28TD;u@Z|So56!h5MCrO*rE~nt z7g-x?D_AH$rU?4u%5#b~vn^xt=J2$?|tif<1j3ZEsJ?#I*vo<<#rxx+tW+>GN;d3eZ|Br;IUBhSaz$42X(^j0}P$u z30#=BJ=yB@++Uvz98BT4H6f8_)_{jAYT7q`(TE*IQJ6qiW4bk zIg`%I@pa$=esDVzHhwVUS?jf949;M+wnzr24a92t%5`|RXr2~Gew1fNASx?kpo!br z;H85YTi`3c7iIsvkPAHdydiX0rTEiY2xYxW zlA(D(hh40iE8SH|@mv=&+iuHOYiw8UD<- zf5L7oUR+FN{K!-Lf@r^!>0S=!i+H;H`EtuV#Ph(+A@Radpy zTWVq-%jmAODp^x)IOyT&;!ClM>tIyzrr)gi%tG3*qFVMO5sjwGZWNlAqs~Ilm{!e$ zZy?$O$aXmDG_JQBniD?Az8jMMmV0bc*fq@c#jSSnV9tuVPk+4EuZ{mQgLmig(;p9L zvg^v2?nPfR2J*T)-k#5l^mO^&Tk~Z`9Vg5gFh4gag^nc5u{Yu&+8(9BO~syqPl+(p zi(KJ$r_W^e%@D;LiM&anV;MsajTyW&R@&MEdukDZV3PX{A~DE0^iTzs?rhz-Nw~b! z3|NO-cDTo1hud3{xbViCNT$!(&-z1(4mz0_B|{DSVz<(_<*jtSwA)zM5l=(8t=~h2 zTokc#A~N=yOCvrReh%p}Gf)mSrefY1DQ;r-VDCf-eiE(%N}#I#J+QrulG^&7_q4~r z#lu92UAAkIliv1bEL20&iy<}bm71qtm|SClt~76dOJjj&qp|YgNsMER>C$tt+MMQX z;d5NK_`foDxie2#xYs5wMg}398es=Jyd}h=NJq6P!9b)MsD^z@4xHqIzYAoErV>#R zITK>ah=(@@8VD6@Hy>9ErEgjYR0U%I&a|5wIMeWh34|qR21<|Eze8UpuvhPLUuag@ zD>H+#3{7s3eS^9UyM+x$nUGh6V*I2#?ln7|=m{flz)f}fXbExM2@G?=C}IZ;omT~J zQpSH{%!Qe7YbKI$DCKo5zq1=J_=mZ_LTZYe>aMfi2NK)y(u$D)-lQEUdE^G5sfiUS zNC}eiddrSNC}&DRavZx)n_u$WkSWW9;`l0ba(a$UC9fyISK-cSzJgpS}_A-iw@5*2V8$FtIo{_NMu&Iur1D(Si_3}F>$rJ*vcj++sF7kWRHg#1&y#$thoK~!jMB4f4)zk-$9OwEc5Eq zE0)ue@Oj2lW5kpp`%wx+x9U99I=KmIsVvO37_rcgs6Q1b;s&CP!-@p&V&KV}E$QNJA&Ta8!1YrgZZOa5fgW9s zF;dy>1jI2gdX*6LM*HeRbC+_$ZgSbB!Pw!W_obVD!n#3~jfes9S;3ohrlzFvK-pab ziu0%Wgze+s${9UE!q58<6Ss4*6>1*3X$(5WuFr{l?FHHw*>AgaVaur2jGQm$r-vB{ z#Kc{#T)uN=Dv0@e+AO5E&@p7U1>??d=J8gKl!&K=tSp!po!>_Fwr}1u)UWk(1k$Gj zr@V9}T*EThGJSzznoXsclu2Puazt1yyKiF_ghfusXf@t7{1z0 zB^g8fK1OEMu49k&#jgde>0TaFrcV7t2iOIzhN$F7%+$xRcym1Evc)kQExFY$ zzU|wIyOJ5e+qn)Ws)jUQ*So`OyTB*ZBYDJ!Ja!CAo*>AS5ZX|Cdgh^2&;^wXKV@Bz zUOZCxwj2n^g`GnbId$e}>n3K1_{UG}q$oQ~nD_KI#17yGZr|!D?)Qewne^VUM-T%; zG4)+3_ww|=0n#sh=AQ7Q--RJp3d3dsPn{K_pxo3~z-8#MF&Taf_Nxgnhsv_xM@hWSTpUcYI(v5gG{l0V{YGcD$Y0X-g;CkK+c14}&1Yy_E zBt(B8+dfchp>KF_u|o^T@8$WpkdebnxxMQ@H+U}&HahsDsKe#*oqB5=XkF_Ar=4=$ z0AkloPn`wJXa2a@b{RgEIjppP-gq^@y0}F{`MdDxQin43AQ{>go8wl2%3%JiKnoy5 zXmTt2amR)s(~CJh?!mre244Z*Dmz-x@#|d=U$1onwWSM>gA>f9hHvj}>-KbGfn7*U z<-s2_IUWabPSdT|a@}BP!-R&WV=Y&&2VgqN*lUMZsagJ)ZJOg$u;IZKyHNLN6dCDY zg%;Iti!#gI4a)yR2kb8PmXXC9g?x}YfkiGJDpb1GY`%o9GN~kOKIlBRLW}BD4&6c8 zQ)=hi@P9+_QTPqMMo{dqzBenl-?rQshKKjrY} zabWu-H`fy9(!;(h(TCr{dTnjEubZHEaQDUhNQxOE_|L-osgHYJuSMEFE-9T-ha>h4 zi4$~s|zP(k6`BUw;fpZO|%9KkKChogx zeOKD~mhl;jnYv*<+7ZMyeVQ_I|K`hk3g)yLh=~$1r6_#w1+VFBGGQEMh#JVDjpYbd z{vS6I%Y~x>I96ID21rhI3vF-3ec{Pwi@nbN?43a(a!DGmzrw2<%{piGC(l0-UzRIP zko%3?z5zqZl{ia9!r*qv4Ch_}kHy!C?UU3UYc}Cnn=7jd7c;xfcEM`y_g<^N?F?=K z5Kv?3@c(8X!MIpc>Y%`>keE3BLq4)FG5-(wSfn9aLD7P`wWB`=^ztp0kTZp#j8c-q z4tM+>@*_6wn}3jmf<44HExy zdB`tVPeR||Efl$+02#;=;wXI>O+^yQE680#H(}ky|Gj=-g6^-HF3BwvwxQCYDwI(H zJjypU(meQ0KC0F4VKcGPJCiiFv=xKbt^SF(!e8sux-tD$C-JHsxkl8i*bGQP!xKxu zaMZ$@{G8+nU&>}8qE1Fk&Q25IKh+T6PLbCbowU^AY4fJs&}3YILRa<;#5Z0%~4j=O~k zPrNADaNWViPzaqTt?eC_WQRH&QHw7*H`gLEITs}jBsrIjauyB4HhwinBEuLKh-l`< zO8CPuf|f}4vyg(CA|vc8qQo55($YjbARVC_GbteTPjYU4aCma=c2+Z-H9-M|dAnwr zhSc}XvjIxl@hZiFwSAl9^roZ)Sq3b4tpKfP;tHaQr>`L=L8`Lj5v`F_n%0|9a`)r# zZ4}1ixW^DHQ(3ef6|CzuIt_qdRz%j0&0|{H;TwO9ZgM%==HQ1VY|{cx6xWTw>Qs}h z5u272NhU5g?Ccl?->!FRMkaQ4-tS*-AODU3?=KT2B6hBydrLo`Tzu0TjH?2q|`qx9v zmPAZo#<_QrY4T_GkXcJR7ZHK9IFJS#tug+I%(MT zXma`1^o*G<;Hi%eESr6Lp``GoLr2n{f{P4G&Nw$vax73gO_lKhS3UhF3!D>ElM

zVK3Rf9Gz3Aoh1CRpku19Q#EM!8s8Rqz8UT8T==@?B>@$v@NSgRbo{xY^JhR1c&q{C)qjI@n-t?s*SH6sNkExpTkSdk}mA z2Rb@Z2Q0R+ueFbiMY_A*9v*s#R3Hv639ib+w;H zan+Zn$@Vz@V$_C|_P#b9pNvK&>cHTSZYQc&fy8Dk^)| zkye3L1Sw@0J}L#)ig}C7Q7r8twNLm?_h>a}4@|f7L2demFx1Y6yIe6?(ZOm| zv>pj;*8=8|57gsPe*+Hl|FjQ`a~q6-(eiG1Ot=>NLDJG43-t8)v`o`BH#AgvXj|r4 zo1s1_@eXvRtS7o8YjwA(V2jn{SE8v<=`~mQ2Zpi!L(LyI4!g4rg27JNe;E}c_T7Y& zP*bI<4(pvx4-}}M7uO-4)~>9@OLnM3pJ^OETLwDI0asjeTJYeP6%85!liwON-VTxs z;A88DFz%|He^^kgXXsI8=xIdx7H|o*jrVkDLvY8BG8QI#vTtox;);wCsf#5 zYy;Q_BtNvmce4l>v-pGz5%DVXe_YSHpUz^Jl1Kz#V(?;E=l*CJR&Duty{z#UNeXPy z$m@sQvW7YIg9LB2C%b3OaAyI3qq~G%`1n;N^M4~nGqD@9U%>fK&lVl!So zMPMe+u`t*TKWnlgY2dKsB~fl0-_9G?Xyol%s1j~FpzauSXxDhsdB%#ZVtT+yI&cAL z*@};6yY4JYk>b~b?x%w#30G)pYo1iYR#Y*h{Sj_<<*iob2a)@dIy&$u%U~BP0d7Vz zx6tpWCMccHxY4I?!pKe5UtU5Vxg)Ai!RdsNEgGc%RCN@_>gJIu_ow6-&rLk3DXfSxrf2HYUo*HQRkg!KXrJc>RI4bc3y&j72f$6V4yvMT8$rrC7lpS{ z#=B||sQFc@f$(m0{>m7D`|SkzMjXXOI`H3EAZ5%K6EUR|3Y-vu{XbxUjU)L8>^l&x za~`|d8uxkClP_p0u(~JhO%MQb?qKQ$TEnVw{p;Er1~1)KHa6b2OkU|V_}_uDswW$b zQaV4$HplsU1zBX_$$^y3Y6xxfoY6qhwmtY~g3-6aEqg=Gc-rThbqNA&>jHvWr>-%U z-D9vpzu2{C!!t}XOJllO+zky14mrS1rwp{N-vP8w-rjD z=#UoCJ8c&q(Oaur7RnnhG4EHw;ZM*n-4Ymo-eemRm@5NHJ!M7sLb;-b<$zgkY7++zz#9U@*6#PF2*2bBlnn-(&kwOMWDj^&o za21Hr!j6@~n%Oo4B9r8~he3ei^MrL~J)0@%Nb-GK^tYhG-Z%J|{@=XRuo-*um7rAw zsiO)qtkiJRl7YkH^MeMvCH;evm8{uunxizwA(fJqKhG5c|7hgm4#TE} zj_>0n4!%i63rJP|i6V(JkTsu-7)-~;N+1OlM)Dx(GC&L%aTXHbe)9*E!DwahjQrm0 zPhq~%Q9u@fFAE{6rwLnWB#q;tfm`90$k5a#)5zlWYMF9H2Q*DuC_yc=xt(Z+xYS@+ z`oV#Ej0>s>PJ%t0F#;YB$2;R!8o83GgFW3ZcgQCapLYUw5#&EN6>x!B3U8VPc5q8R)U(OZZC z3y>BiuxTe?ExX~M5uOJq;km$OEwf9M@S&=225Sh%1WOu#Iu@kxI|inFb9A)5O{XO~ zvSgXh_)}*757Vt$ttj}q)__KLh0eaYI1*A*;$^5>)4)?z{WpM~Jr3J(6cpZAt(RVO z1eS5*LaW>tbW=)_LzfB*?rJR1Fq@r$w%_j^g*BQfJ$Op_OsJjQDDcPt+LiUY#ZxRA z*=ro1*WY$10*@HT@Y|6)!SARXHrJ1iSW1OeP59ZABBRojroe8^{mxTrjwN$E$35N+ zPt|}FeG2PUl>iJ&^howrQMJ0ja9V50)Pi|N{NXb85^w6c72+LG zj)hoypNN5Z*0@v)&AbnZkz--kgcg%tQ7F^jtuwE!S3Vdn8QR@qV-GDqYOFNT1NhN>#_3ru#$iIx46S9 z;1=?d6Dqzkf@-EE=#RPVJ(*!^$}LR+1oB; z{0Z@ULU|1_&Yj>h6Z*wTJ#+g8f0YTL`w9FaM6T`wg{dzj`=3ZaNGm7Ax9NX;Xwc7_ zWpihv39iz4l{bmMxORDq=B9c?oLgh14qlnCLVj@!BV`=E6Ck$8P(5oP`98L=cmg2;~g*SfJM3Je{uKu&NDBX7En>PjTReSIb-bO*n**LM1j z`f8zYR@bD08eFpw(W~)l_d5=|$CRyVj3`p1c761>(t=#H08})7=>+vx_#4u%y2^%0 zP9MNRyU-wpdnD3YNM#!i3-mu`%>Ot6SJ%T?fuvSJ=_81+a+YS=s@ zTEE*z$%|7AMwAxQkun3aiFh0#acRz7dAs*#jAY-?kH03?PG;!!r_?*g6hi$FYpU5> zPhy&wzg@M4+_B=<-xLtc%_imh8M#eLxQHf5ThbOSz87&c2-rT|h$kRp$>uyz&sG3E zaSA-Wuf`rcZZ1m)`K-hb`c8>NW_eh?zCc&vj{c{Tdaptt9ew6F^24_&v4{a2{l8CC z&*;>t(&#dwK8o*M;K2sJBSebe*`2vb@x-MNZ$OVu?*>|&wwr<1bt6BcjPw zOU^aWR*>Y!$m~5Se{4L5rVKKF7rH95ZH_hT1WoCIsOXxoYWd$XwfZpVg74s8BtlLA|CHmjF|Op%vD~>z5!p+c?M%Wwz0Jh;ZzY`ZqF|Z&Wt-_Mr?a z>zGEp(JiCPIJWRQXPSJOvIZs?j1CXZK{BMD(4o$G}cc zXS0dx482RQcecS2B!EBx)tbwd3`~q+`(%|)h!M7hDv9G$T&%~~Rfls1L8J{tUhO^u zF^2LPNDg5gQL{mKnbX%2G#WBti|~A-aXWd)D>NB^N59V?f|RryL$ET*-qA~2znuS~ z#)6nsC-oNm0b_l10wV8Pckko+-%S-RPsuMsiO}l;4tlg8VPHdPZsh9czI2>GS5*an zKhDt;EK=3=IinaW_0W4MOiRY#-Olk{6cq&cG^MQi5srN_nfDK=Rx%?0M9!9n)4a-I zA1F?E{MEV7UwcKpv4+kep&<7g&ILbe_Hq&UZ6@se7LAnPAs4tVfK2` z%q6hxi9b{1B0wmkG=WBR+18nCmD&@|=8QV6vl`d_cNNIf2%DkMK}SFi?oRa5`QoE7 z(5+ubuQ>^>&DgcaTaL}C(Zx6vRe`F>5q!9u-tb;yFx@ZfMxPv#@Lc17{J`jFSob*6 zdh@01f1K!=@X)-s?y%R03u8Y-2i#f9_JwZbHU>BG?1B!yF9dWnJzs3Q5S-z zjfn_vherUJQSk-^kp)zsD+K5BCxa1T~c=ls)(!S2zaIWM{c*#s0x0 zrUG@>0tVt#I%N@zf}ja**nJIkX3$amQr9=z`901H#zm0UDb2lBf)PGCabQsG)uIXa zRmsy5U2~wNPQJNH$~@~}bio|sq8j%H2t5a;-LCCiZU@`8IN%up(fA*R2uG#6JU0k} zxxI7>eK;~qq#Dksf@?j0>HnqXL7}>bdjWwCl9%GWgsjWDf@BUYs1p9PKOq!NxQwv9 zCv2;&;kzyPFd@{Y5WDstf6@^JfL9>J!cXIa9FTFr4BvrN&wHF$Zo$3*`;Pe){4neltAa{vC3oO%B`@ zm6k9O-Po_QjW${x9gQcuMyDe!_)A^jO}_jq^6ksKW^{ogQo(zGVF1^?KU68QLbQ>$ zhQHEmM}`ryXZus4K&sG9717*Dxtljt{g9>n&cPW?sFl4sKTRV^tOGvqF0iT(k8$Z2 z9Gf+NzeR!~nk&jwmROYMyp(qtZu8|)`$ClYFDW|byBL$7(4L_EO-O0QhC!Gf6qg`; zTA^~A1n=?Jhp;$i5!>1I$z^$=WAuh$krnYD37L)%aK#0qP~EL7$aCKM8jb#vXmv@L z)avK8_EX35b7Ng>;-`BHVf&p_>Y8$Yp6XyPYOS2M6)0Fg7_C_~kl3M4en`78629~~i z=jXHOV+R6@1F%`%)Kg_yK~d;z1LZ@MFLwfS z!Js}*V1OJiFLEiQ=hh+ZZz_N}L;p{pL(fnyq0U$-_S+qp}H_)`HLjak|>$nA*#Hg7&W@mK~=d`6^?{c_q+7Rd<1jDfA5 zJi*?@`=+yShbA@X#enDcu_)N!cP1CQjzM23@M{S&$w&sT`?0YkONK|~yXDXz80yO6 z%78olqope<>j~)5_(B@`PZ;9hZ0ld4OJSe%iv1jdG%i z0oSKQb?EPC_}2)O)sNashx!icN&6OmA7Qx|Wg~}80uJl=u(aW@^~bD6^n}c@HtVY~ z6W47%Yp7?>Mc?kRi0lrnBbM3Ovu|8vcrPQ*KvcJDiU2Wyy*w$ByW)MNPaZ*Y5aFP6 z-nGc6+OW_>{ouORq=x8b72I;`TWI)-pX=+x#uF_#yy@Pl4$&!+&zB{E{*V6ay&SiV zy}UdZ9_AQiUpnnbJ{SXrOeDh7ZQ7sg4d*@fY^>`KQ=tZ|Ko_=erZnfb25Yt~!s zh9jr_Q-F1s!6gRcfHsp^9?k=IC5~t-8HWzo^kv1cXkdKGVWQ*?tISscx zoDo^_lHEA00_&Q8;Y;FEJuvw|obJ->eL#n~jYVm+q}eRc8uwgai9gCdv}$u~EjcDSQ}oHiPN|yGq-E`TxDFb=v^4bj#Bj3#daS>@mULo$@6egCYEUVtHCPy6 zOiU?_c~}4}J2MkAGZQB>TMA!37T*8U)X&GNz-9Y7j{0fg=;Tbo#?Ja5GK%FZS$GzV z2FOa2j@{%y8@axtahEw}ntC#3X8O&w#$UO@9Dl*^yBEj2{Sfz8N0FZ7CG;+G&i8Vw zO6WBy$J#!_I*m{LxbI4qWl=_%lD`n%j%y9m9zpSAxWl`K8w@Boz|eo>O*v9xjO?i~ zF-L`x_CpbvVWRto;+tDg1~0CLvX-sZ%K&&)wUFps=&yVUePTPki5OfB2Qn6^L|OrT zf-0~gDoi+2G{qE8C<7M7P2of#79;e{AY=$WF}U3K9;WwxxT(y{)yI<>fvjGAQ6jkG z(x#mw4tmTJZ6P>%th~Pi`=p}pJSHmV9k50!mrEDDOrym(B*L4B!okdzAv3vQOo2cl zWQl}>?^>8n{RUCFq&ul-BqnlV;|6I99G<qnD>dzo zPc2)oTki`kvRym9{SF%2#A{A~YKo0MCO%~=jN}5Nd4i)QuV0QOqEa!_+1c)Nj|-~GcQ4swTJOcH{4aw4X_Hqa2~ZY zebe=Df2y}we?PxN^$r!2aEO5{>1wFlD#NRqv(9ia(+EH>-kEG|m*0BtDBeoaZJf>y z>*l%V(#JWh-eeDb5_?s^-151-x$1sfO?eGn%`;H^=fjUC@Fd-zZFRFF zr24NOEcLm@ZYU&e&WYDq3cx8FtW-8E$#k(yEIa;y@(OL79MTVp8YzZA=77J`;dmY$ zut`nal<|xck@W)Um-WK1-LgpeSsFBb{9F*nofTFw$i{k7Zo2kk&oj9~8`&o$F^4$2 zi0n60xNkW381+wzyE*A4W8Om1;(QUkLg{<)MNz^1;zh7}xJchzs3OZJGLIJ0al4@#Gp7SxtM3;Y9d8% z{7s^_w}EJRPQeIV@)liJwXvkPi3c3K60uUo&yfNq!>|X+Lw`u}v7m5#BeOV#oy}98 zxY%GCR753)hxo<8a)83RAH*sTO&NDGI-bXH*1T2j4<~$%l@Q0cva|=sl~I+-I9csz zS`cI$n>-H6STRDFNe!u3uv5;tM6D{DJY-;1ey}u7t)+Avlfh{+&Aea8oNFeAXkz7( zDs}n3QxEx?GYYw8hmJ|Gna?!L7zd>pgcv1kP%v6}VS`13C{V#lvmN}m@D7d*slOl7 zaSwF8A`>;YYXTQ>yV~jJDnnmk^uXHGlFL!#P2tn`JA1@k1}c(mXVK{h7ZsBsV`j`W z=ixwYiIj$McPm|RbxHfIj!GHmGWQl4_%KLS^Q4A+zDq~7%(bvg%mmYV2WAV(O8@g? z?Ws*K%+0}uNx*cDK#SG9P6p1*QB6kr3N+$S^G|lJMnSNf)$Y-SJ3x)g3&J;S6a z&09QPfwB^{&S=XnsH>dVqqe8-?qR!>-vmVM6EI@26M!!}UQO2Q-&%!Jx3x-I$CbBm z2P?B8U_Li`!Yu<1Me`@FTs104{6xItrh_BnRhg5Ts8eg1n5rJWgm3u*r(JMFj8Efc zLkC_ZPu#TKJ|T2k-q2IIL+Bz-2@U(UdxnU7KRN@rSsV zFIP5lXnpYCC<@1C_lLFu|OgHd$9P%6mP zBrD^wgyU7(RwXbV@2V?b>%}gVZ#A~1IuIzr<$zVZ)`7~&i618M~>3>TkgObNUgy+BX>vJM=%B$@R;$ohr+61#+ zf0@XVqzke6n@g2Yx`f|Z;n_X^GQFqqSs^eaL^p(;LCGfN6XE6{pE42rb)DYM=z6cn zb@vT&h;7g~Y($|MajcGfBtq~pLHLOF+YrzQVGKL0luduQ7GGVV&n}+xS%3XFqZmGc zmhz23+`_eRvaIJZfWIwF$wb^a=7ivjO>Vyf4#83dY7@WxkPpg+;Yalx?~*6dSnJ;p z??Vryf|AEA23HQI4gO`5GK(vX9rrAKk+TVx_6DJa!sEfXlIDR{E%&Iq*4O*o!D!T~ zbUl+JN3qdO_p(3Bw{5)xVjEh6>F|+piF`~nA$)=N#(%?`5g#%# ztv)2;adLIlTr)FrrH&Mx)4bE=PFi}4MQ#mnB|UH|GA;}>M34JIGb?}K{x4WyPNAy7 zA_JIMbm174Ej)jbu&^<)z%iY`#e3X+-C$;U_1b-XHw3c`m7>Oy2G#giO2Vo< z%4BW0pDrAdj&5|+>QZV{V!0a8PAWL+7ganx7U_gu;1Y?{vmaW$ERg+~VQ0pdhMR@k zqc1APhx_g80W|S(%c2Y8;tuZs%Z94;(Pw}JU0MOXgQ{7~0RtSqCY>Xk&2sJBNXkb?7SI5T#7y zC7N~>7dY+UV_21v4s69BQluC&gWfk+73*N5w*nU<^`ZQ7_fbTnnW19L14z#BE;Jx= zBy2d%u4(Q_t&V2Me6`AGV`v|zV`b8Sa4_QW}?AEWs*VUe2wtmO@z*p>q zS~)gOa?5xvbO*PMkd5?F>4a<F=Xq2DWA7qTin#C5Ahm(9%(F0~V3@d~sZN8Acs z53$sh3g{gbtkTq#MBwEM?yQ}ch-Vs{anG!*#J{JnBG!#WsGKmO8258uFP9kfFboGd zA!C;95MwWp9yLnmIK4y;=|yg-|7rhFVy4VoDE5iDoN4I`kkh@WCTn@38o~;nE2t^C zFB!~tu%$iw^=?sTPN4PpFbjOZ)tP5zM0mOZNjS#Sx5D~n*EOiD)RVgEi)*jvgE3*Z z3SV7zD8`d*6%jmMK!Qdi@#llf;|Eq9uTcu-*Na-6xKZcE%G&G3PkvYK(=oUmlDK=6Ug}17-;YmJ17j0qY)qlZgWk~M(Psj!%sJ^yV`j3Cyb;w2|mH;GS ze{UES7|j7PhSeQLtVXYx1F26#YT;t&p=HDoHmDmFIE4Fk8VDey^3KI2MlD0Gv}e)p z$40l_q*d9Q01Z}PzuecNKDFpx#8-cOt@LXKig zA>}|(iKb18HPp&w8Gd%~ISf9OU@P-&LNFcdU8d6@`Dd~(f5aSAdaF0AjP8qMR%FA5 z0l<6VmsJbzIzY4v|7sve;1_5QgEWB31vj$GmFbsY4<|Q(n;P6;kECT!#Lz3&3X!r0 zrxR>tPiWgK+X~sThqM{&bpu1xyPW8IraxG*{d6>3%tH5olijQA4mGm}*%_pMgSXwQ z?GAmt2ky;g97SUmkZS&4tzCCe)X$QaEOC*HWKa;v3rLhGL4p#LAaTho;F1LdzLJ%& z1cfDoWCUda36kTYvVi2Mz^-Hzkhs9Y+uytUy?1q0_s7*;)l^Sc&s0xMO-=WwYkFqj z8U_*ryn^Y}-M}N?z-yUm!{S8as99(GI{8*kgKMrF_73v%q~qPQ?2?qZHk4)I^;O-` zut2fQ)uHU(p;$5QvI7tbi|e^vU~>9!ptza6QH|UR!r>Xmg=7ruemX<)9Ky35N8(LS z*A0;;)>&rbjAQg>c+iV_6Yg_^8_R_5A(MYS*3`iy1Pu2mK--^{Sf#_%gv9Yo=`Bz9 z=4SQ1**|nWZYG~zCSQoQ^5)>~WemE?YI>RuLtVC$JX=;#e&M=%s}#6g^SMvM&UZ{5 zL|Ma|zmkOW%MHsn*$G|PWBJidAt}iMJI^&JnVaSDyN_^hF&KBw7DxDd2;--BP?p@A ze~b|BKuhh^ORZkan~QZhECcr@DpJ6VZF@XPmUP@dxOm=RV+4i4Sm^E=$z_0)Cu~5q z{4-Z;>6X$6dMFod5YS?)V&bw5upz>(rFv{7P29?Vwn%?pe5m!_Z-$QNGg8o?mje48}{m{F2_-o_Q*)=*2ud0st(kYi27dlUe8E_QThEa*s ze2G115{k0?^AR0tW&B9pnc2b;^LR>l=y{>}M-1gucgV~Y4hUm&6T3(+3H?^Lh4P07 z4O`{dB!~9wh?qd!sByLCGxcf}#~wg=vlG`jNg?%c@gQMG1zMl`JlUTahHiq%pDSmVoDh0RgwUYD^EFK9#Mp_jEUH-&Aq7R&v$HuShF z=g4Jhbj`f<8g_OPl`Klf0z_CU+-y@@$9`3vbbk|P4imxGVbb(EtJkeYn~Gpsi}8Pr z^u+8V;S_2kH+|UBxB+m8xNRcAX{^-~^Z9X!CBK|T-EA;`h$FMY8=PGkPi{QLTGZ{> zjLc`K{!z10e^H|iB=aW`UvuqBXvfyY#_Ng~r_5wlsXuk;E0fqh^1qcLPeoZ=O>MIv zO|7#a*1p&@z0P$uSaI_Y%b=P|(WC(*zSl>?;cdh962>PU5S#13cO@=Y#|pbFZSxCn zrs*hu4G#fbwvR_IoWneLIImP4Pw^pLU|d8Zhf`8W61Dxt!vfj+ z*OX(0=-uB@xML7NC)2SC*=zU|^-HH|5lK}snvYsHs+H}8{GTHP!@VF2XGFQb5=*|Q zURpVDMFv((R+hfnG#Aibqzh9j`IXYBIZ3ytm*p#HK&%e5HO-w2EtL1CKi+R-qeSXt>bHgq#foLQ0aKkm0knV@^slVO^ zyXs`0yaw2h)5--_#uZXB$_wJz)RoZR6v)oT`Yzkqgo28DIk+0vky>$LilN^WvILXa zw@{ry>Si0?n*0hKjzQyg!;BR|1JEkQv_cX&EZeJ)VPKTwlh^9 zN*E1C7qR9h$T7v1@(uTca&0Vyj}#A0uw%slC<~&y54_D?O4-%y0a2=!9C&L&t0~pv zT*5S?dc0ddji|qRBUE?&jJbI1^QqQ5ao?a;6UTWTRQpeM?Td%tum{7%2dkRBy^;+6 zaVFRiEpkfHx15N7tc2oXKsRB zeTbT^0=jN$W`imfOK`g`P-Xl^b2KRS*$e$x@)*A5I0A8x1DRm4cCQj>sWesC^y<+u zMyMn{_Bfacwq_dBa$*=>ll31)p536!_iE{ySV}>B0&5qWXta+7X@V*C*+qag_-|`p z{UROtm#^l4xI_JQiZUJ}0rIIHMGFwYc}MRm*$Zt)en(Oq_4vpW2`w|_#ug)mWy60D z?kygv%j;;oKVMpxJPDTY;GMKYZ4Ed*XCXLmw{BVajO&XtEa}=VN5s~Vx?Oty2uEIL ztLvY?26c1rj-29HK7R=BAn|=yuoGdhxkkYYoLY|U?;lQ_41YZVV99C>hx?2viuiLH zj8zYVj!99$qFTk}ZP||FW6Y1HT{@Mo*;9PBhnmoH6e}W>!Ed6fv~nJhhFcU45Z|3V zMwwubYx*hS>tf_jH+@W#b3)oiu}R#pgZ25G>2u&ceBPpT;Pzed4WIk429~05i7w)H z+AfK^F6-|NlR5!;PG(Qyj!j&M=?4n;U9k8ng1htJq;x>yZurKYezILi=r?TC44qn( zm$b2J+-PBqI5--;$txB12z9#NR+=x1v3>Qscu+0mY~9x_GVySf-GVYn=5Paqfq#B5 z0B}`7XscraklbL4^soz-Vp!uGLh;*H{mhZdIDJ06fwk~?>GM@wvMjyrhVF* zE^|22$$_wr682mJ-+>gsYUTR+x2DD0dQtT;NnvUVx@udr5fK*aQrJKX-*e0Mh<54cr0He@v9% z6g5H-u6FfJ)4*?;cT-tpmtE|Gv>xx-^iov##tFc0DfF;e$t6zEQUye50N)FZrUSNG zp4v>mM^yJ*JM_MH|HRih`?R;-xIN?1eltueV7x8l6YDLT-w#Zqc#^g-eh}po$Wm^a zpWY?{ZN#l-3P^FVO6z_hzDfN?)TmA^m_@w%)dVLVYK>NKrp|oZMvOKBYu?AFjja&! zB^vpD+sFP9MC!T6?Dc!>0qS2Ue8B;@?G|*PjY+HR5B;HrML3m%*&%U$>1tz*R-#?# zK&Af5gmeE^hsQ+NRHZ&*8Xr3~xQi0vN&Ppx%h0H}1j|0V&|ave_w>ukF&I+nKnNm5%b(hn&OFxLLW|_7v=GiW{N|%m(L@t#A^-s~1dbMF<96xZi)Vy@H!S2=8 z41Z1eYIz6~YcIo6TJEX>&(Fb#Q-wpn&9#Y;nu?uVH+`omD1*WRy;Scct zCjs!kRq}JVvLLy9H6gH~>)OBO@!y%>38pS(DYLpMS*EV56Isd-7ropp2G_E_EbanJ zgmVIfGSl5Tkk2`M5&)kqfOD$A9F}#$DQxI%$d_|+r!w+cJ>(^?bUNBIW{{8~GZi81 z;1ZwdMauXIUCq1yNl`ihjRt|;k62U*CF5iPqJgWn1=hXcQW_!2(|7mA1FW#{4)YD(MLpyA)6E7GHNnBRR*B#%g7m<3+kKS(h>a;FxCnvqA zAU*E^4vyVsw=i^Sv~yy~%7Wpt^6qD$O;_gwSI5I$^yy9ZVo>T}4yvTBW8g;vbW^3c+agiAj7aQTLWO?)x6`>DqoX5AtC0yP4l zMoVSz9tqfW-|UMW)$2OuW9WAh`4`aa*`qx9mJFApOJ7c#htlO25YF$q(jy(rI&$L% z7Y*_)=`I~DD)6V}Sp{4Dqj@s>_$?oQx%V?o3UD_CxpcGh6a36k8D!1D&u)A8Nvhd- zpDLWTzqVJVk$6C5ZsrR5N7T$wRV_eKJ8RAelG)=uDu80tw-qP*qGryj0w`*+=38_Q zpbt}AZZi?Fe-k2A5L*y^PATnE5;Jb(pBL#AwF&720?SONs8+ULArb*OI7*0sEQ0Bu zhd36?KBlP6L;Sl*LX^;c?Bf~bJg@Gle5Zt#25=|Qoa4Q7W#EAqp*|WI2DvBDC6_Q? zuGb{V>lsBETU>E8ii?q?OR$#`jVMLZ2-+(cXpoc@QjSZKh}hq(j{Hyi_CK4qvG^LE uEMO8A>iYANL|Wt9FqQLDCqI8*XNVV-Gr}Cj!bmLxmI71Vys7n2o9Z7oiH1i2 From 04586e634e3753140fd4013b977c14daf7b87336 Mon Sep 17 00:00:00 2001 From: Giacomo Fiorin Date: Thu, 2 Jun 2022 11:52:39 -0400 Subject: [PATCH 292/585] Remove trailing whitespace from Lepton per suggestion from @akohlmey --- .../include/lepton/CompiledExpression.h | 4 +- .../include/lepton/CompiledVectorExpression.h | 8 +-- .../lepton/include/lepton/CustomFunction.h | 2 +- .../lepton/include/lepton/ExpressionProgram.h | 2 +- lib/colvars/lepton/include/lepton/Operation.h | 2 +- .../lepton/include/lepton/ParsedExpression.h | 2 +- lib/colvars/lepton/src/CompiledExpression.cpp | 66 +++++++++---------- lib/colvars/lepton/src/ExpressionTreeNode.cpp | 6 +- lib/colvars/lepton/src/MSVC_erfc.h | 4 +- lib/colvars/lepton/src/ParsedExpression.cpp | 6 +- lib/colvars/lepton/src/Parser.cpp | 2 +- 11 files changed, 52 insertions(+), 52 deletions(-) diff --git a/lib/colvars/lepton/include/lepton/CompiledExpression.h b/lib/colvars/lepton/include/lepton/CompiledExpression.h index 84ec2eb410..82d66d5c6a 100644 --- a/lib/colvars/lepton/include/lepton/CompiledExpression.h +++ b/lib/colvars/lepton/include/lepton/CompiledExpression.h @@ -56,9 +56,9 @@ class ParsedExpression; * A CompiledExpression is a highly optimized representation of an expression for cases when you want to evaluate * it many times as quickly as possible. You should treat it as an opaque object; none of the internal representation * is visible. - * + * * A CompiledExpression is created by calling createCompiledExpression() on a ParsedExpression. - * + * * WARNING: CompiledExpression is NOT thread safe. You should never access a CompiledExpression from two threads at * the same time. */ diff --git a/lib/colvars/lepton/include/lepton/CompiledVectorExpression.h b/lib/colvars/lepton/include/lepton/CompiledVectorExpression.h index a9dd936750..ea3586f1b0 100644 --- a/lib/colvars/lepton/include/lepton/CompiledVectorExpression.h +++ b/lib/colvars/lepton/include/lepton/CompiledVectorExpression.h @@ -59,12 +59,12 @@ class ParsedExpression; * vector unit (AVX on x86, NEON on ARM) to evaluate the expression for multiple sets of arguments at once. It also differs * from CompiledExpression and ParsedExpression in using single precision rather than double precision to evaluate the expression. * You should treat it as an opaque object; none of the internal representation is visible. - * + * * A CompiledVectorExpression is created by calling createCompiledVectorExpression() on a ParsedExpression. When you create * it, you must specify the width of the vectors on which to compute the expression. The allowed widths depend on the type of * CPU it is running on. 4 is always allowed, and 8 is allowed on x86 processors with AVX. Call getAllowedWidths() to query * the allowed values. - * + * * WARNING: CompiledVectorExpression is NOT thread safe. You should never access a CompiledVectorExpression from two threads at * the same time. */ @@ -86,7 +86,7 @@ public: /** * Get a pointer to the memory location where the value of a particular variable is stored. This can be used * to set the value of the variable before calling evaluate(). - * + * * @param name the name of the variable to query * @return a pointer to N floating point values, where N is the vector width */ @@ -100,7 +100,7 @@ public: void setVariableLocations(std::map& variableLocations); /** * Evaluate the expression. The values of all variables should have been set before calling this. - * + * * @return a pointer to N floating point values, where N is the vector width */ const float* evaluate() const; diff --git a/lib/colvars/lepton/include/lepton/CustomFunction.h b/lib/colvars/lepton/include/lepton/CustomFunction.h index 7b6a2b6834..fbb0ddd52a 100644 --- a/lib/colvars/lepton/include/lepton/CustomFunction.h +++ b/lib/colvars/lepton/include/lepton/CustomFunction.h @@ -83,7 +83,7 @@ class LEPTON_EXPORT PlaceholderFunction : public CustomFunction { public: /** * Create a Placeholder function. - * + * * @param numArgs the number of arguments the function expects */ PlaceholderFunction(int numArgs) : numArgs(numArgs) { diff --git a/lib/colvars/lepton/include/lepton/ExpressionProgram.h b/lib/colvars/lepton/include/lepton/ExpressionProgram.h index e989906288..a49a9094d0 100644 --- a/lib/colvars/lepton/include/lepton/ExpressionProgram.h +++ b/lib/colvars/lepton/include/lepton/ExpressionProgram.h @@ -67,7 +67,7 @@ public: const Operation& getOperation(int index) const; /** * Change an Operation in this program. - * + * * The Operation must have been allocated on the heap with the "new" operator. * The ExpressionProgram assumes ownership of it and will delete it when it * is no longer needed. diff --git a/lib/colvars/lepton/include/lepton/Operation.h b/lib/colvars/lepton/include/lepton/Operation.h index 4b8969cd59..1ddde0b8c0 100644 --- a/lib/colvars/lepton/include/lepton/Operation.h +++ b/lib/colvars/lepton/include/lepton/Operation.h @@ -1017,7 +1017,7 @@ public: double evaluate(double* args, const std::map& variables) const { if (isIntPower) { // Integer powers can be computed much more quickly by repeated multiplication. - + int exponent = intValue; double base = args[0]; if (exponent < 0) { diff --git a/lib/colvars/lepton/include/lepton/ParsedExpression.h b/lib/colvars/lepton/include/lepton/ParsedExpression.h index 6c6526e525..e2a7572c4a 100644 --- a/lib/colvars/lepton/include/lepton/ParsedExpression.h +++ b/lib/colvars/lepton/include/lepton/ParsedExpression.h @@ -106,7 +106,7 @@ public: /** * Create a CompiledVectorExpression that allows the expression to be evaluated efficiently * using the CPU's vector unit. - * + * * @param width the width of the vectors to evaluate it on. The allowed values * depend on the CPU. 4 is always allowed, and 8 is allowed on * x86 processors with AVX. Call CompiledVectorExpression::getAllowedWidths() diff --git a/lib/colvars/lepton/src/CompiledExpression.cpp b/lib/colvars/lepton/src/CompiledExpression.cpp index 8a0239b04f..d8b6e112b2 100644 --- a/lib/colvars/lepton/src/CompiledExpression.cpp +++ b/lib/colvars/lepton/src/CompiledExpression.cpp @@ -84,17 +84,17 @@ CompiledExpression& CompiledExpression::operator=(const CompiledExpression& expr void CompiledExpression::compileExpression(const ExpressionTreeNode& node, vector >& temps) { if (findTempIndex(node, temps) != -1) return; // We have already processed a node identical to this one. - + // Process the child nodes. - + vector args; for (int i = 0; i < node.getChildren().size(); i++) { compileExpression(node.getChildren()[i], temps); args.push_back(findTempIndex(node.getChildren()[i], temps)); } - + // Process this node. - + if (node.getOperation().getId() == Operation::VARIABLE) { variableIndices[node.getOperation().getName()] = (int) workspace.size(); variableNames.insert(node.getOperation().getName()); @@ -108,7 +108,7 @@ void CompiledExpression::compileExpression(const ExpressionTreeNode& node, vecto arguments[stepIndex].push_back(0); // The value won't actually be used. We just need something there. else { // If the arguments are sequential, we can just pass a pointer to the first one. - + bool sequential = true; for (int i = 1; i < args.size(); i++) if (args[i] != args[i-1]+1) @@ -148,12 +148,12 @@ void CompiledExpression::setVariableLocations(map& variableLoca variablePointers = variableLocations; #ifdef LEPTON_USE_JIT // Rebuild the JIT code. - + if (workspace.size() > 0) generateJitCode(); #endif // Make a list of all variables we will need to copy before evaluating the expression. - + variablesToCopy.clear(); for (map::const_iterator iter = variableIndices.begin(); iter != variableIndices.end(); ++iter) { map::iterator pointer = variablePointers.find(iter->first); @@ -169,7 +169,7 @@ double CompiledExpression::evaluate() const { *variablesToCopy[i].first = *variablesToCopy[i].second; // Loop over the operations and evaluate each one. - + for (int step = 0; step < operation.size(); step++) { const vector& args = arguments[step]; if (args.size() == 1) @@ -245,9 +245,9 @@ void CompiledExpression::generateJitCode() { vector > groups, groupPowers; vector stepGroup; findPowerGroups(groups, groupPowers, stepGroup); - + // Load the arguments into variables. - + for (set::const_iterator iter = variableNames.begin(); iter != variableNames.end(); ++iter) { map::iterator index = variableIndices.find(*iter); arm::Gp variablePointer = c.newIntPtr(); @@ -256,11 +256,11 @@ void CompiledExpression::generateJitCode() { } // Make a list of all constants that will be needed for evaluation. - + vector operationConstantIndex(operation.size(), -1); for (int step = 0; step < (int) operation.size(); step++) { // Find the constant value (if any) used by this operation. - + Operation& op = *operation[step]; double value; if (op.getId() == Operation::CONSTANT) @@ -283,9 +283,9 @@ void CompiledExpression::generateJitCode() { } else continue; - + // See if we already have a variable for this constant. - + for (int i = 0; i < (int) constants.size(); i++) if (value == constants[i]) { operationConstantIndex[step] = i; @@ -296,9 +296,9 @@ void CompiledExpression::generateJitCode() { constants.push_back(value); } } - + // Load constants into variables. - + vector constantVar(constants.size()); if (constants.size() > 0) { arm::Gp constantsPointer = c.newIntPtr(); @@ -360,13 +360,13 @@ void CompiledExpression::generateJitCode() { vector args = arguments[step]; if (args.size() == 1) { // One or more sequential arguments. Fill out the list. - + for (int i = 1; i < op.getNumArguments(); i++) args.push_back(args[0]+i); } - + // Generate instructions to execute this operation. - + switch (op.getId()) { case Operation::CONSTANT: c.fmov(workspaceVar[target[step]], constantVar[operationConstantIndex[step]]); @@ -476,7 +476,7 @@ void CompiledExpression::generateJitCode() { break; default: // Just invoke evaluateOperation(). - + for (int i = 0; i < (int) args.size(); i++) c.str(workspaceVar[args[i]], arm::ptr(argsPointer, 8*i)); arm::Gp fn = c.newIntPtr(); @@ -532,7 +532,7 @@ void CompiledExpression::generateJitCode() { findPowerGroups(groups, groupPowers, stepGroup); // Load the arguments into variables. - + x86::Gp variablePointer = c.newIntPtr(); for (set::const_iterator iter = variableNames.begin(); iter != variableNames.end(); ++iter) { map::iterator index = variableIndices.find(*iter); @@ -541,11 +541,11 @@ void CompiledExpression::generateJitCode() { } // Make a list of all constants that will be needed for evaluation. - + vector operationConstantIndex(operation.size(), -1); for (int step = 0; step < (int) operation.size(); step++) { // Find the constant value (if any) used by this operation. - + Operation& op = *operation[step]; double value; if (op.getId() == Operation::CONSTANT) @@ -572,9 +572,9 @@ void CompiledExpression::generateJitCode() { } else continue; - + // See if we already have a variable for this constant. - + for (int i = 0; i < (int) constants.size(); i++) if (value == constants[i]) { operationConstantIndex[step] = i; @@ -585,9 +585,9 @@ void CompiledExpression::generateJitCode() { constants.push_back(value); } } - + // Load constants into variables. - + vector constantVar(constants.size()); if (constants.size() > 0) { x86::Gp constantsPointer = c.newIntPtr(); @@ -597,9 +597,9 @@ void CompiledExpression::generateJitCode() { c.vmovsd(constantVar[i], x86::ptr(constantsPointer, 8*i, 0)); } } - + // Evaluate the operations. - + vector hasComputedPower(operation.size(), false); for (int step = 0; step < (int) operation.size(); step++) { if (hasComputedPower[step]) @@ -649,13 +649,13 @@ void CompiledExpression::generateJitCode() { vector args = arguments[step]; if (args.size() == 1) { // One or more sequential arguments. Fill out the list. - + for (int i = 1; i < op.getNumArguments(); i++) args.push_back(args[0]+i); } - + // Generate instructions to execute this operation. - + switch (op.getId()) { case Operation::CONSTANT: c.vmovsd(workspaceVar[target[step]], constantVar[operationConstantIndex[step]], constantVar[operationConstantIndex[step]]); @@ -772,7 +772,7 @@ void CompiledExpression::generateJitCode() { } default: // Just invoke evaluateOperation(). - + for (int i = 0; i < (int) args.size(); i++) c.vmovsd(x86::ptr(argsPointer, 8*i, 0), workspaceVar[args[i]]); x86::Gp fn = c.newIntPtr(); diff --git a/lib/colvars/lepton/src/ExpressionTreeNode.cpp b/lib/colvars/lepton/src/ExpressionTreeNode.cpp index 78432c1bfc..b7a376528d 100644 --- a/lib/colvars/lepton/src/ExpressionTreeNode.cpp +++ b/lib/colvars/lepton/src/ExpressionTreeNode.cpp @@ -132,7 +132,7 @@ void ExpressionTreeNode::assignTags(vector& examples) child.assignTags(examples); if (numTags == examples.size()) { // All the children matched existing tags, so possibly this node does too. - + for (int i = 0; i < examples.size(); i++) { const ExpressionTreeNode& example = *examples[i]; bool matches = (getChildren().size() == example.getChildren().size() && getOperation() == example.getOperation()); @@ -145,9 +145,9 @@ void ExpressionTreeNode::assignTags(vector& examples) } } } - + // This node does not match any previous node, so assign a new tag. - + tag = examples.size(); examples.push_back(this); } diff --git a/lib/colvars/lepton/src/MSVC_erfc.h b/lib/colvars/lepton/src/MSVC_erfc.h index 2c6b619e89..b1cd87a289 100644 --- a/lib/colvars/lepton/src/MSVC_erfc.h +++ b/lib/colvars/lepton/src/MSVC_erfc.h @@ -3,7 +3,7 @@ /* * Up to version 11 (VC++ 2012), Microsoft does not support the - * standard C99 erf() and erfc() functions so we have to fake them here. + * standard C99 erf() and erfc() functions so we have to fake them here. * These were added in version 12 (VC++ 2013), which sets _MSC_VER=1800 * (VC11 has _MSC_VER=1700). */ @@ -15,7 +15,7 @@ #endif #if defined(_MSC_VER) -#if _MSC_VER <= 1700 // 1700 is VC11, 1800 is VC12 +#if _MSC_VER <= 1700 // 1700 is VC11, 1800 is VC12 /*************************** * erf.cpp * author: Steve Strand diff --git a/lib/colvars/lepton/src/ParsedExpression.cpp b/lib/colvars/lepton/src/ParsedExpression.cpp index f3f18fccd2..ea2cf707d6 100644 --- a/lib/colvars/lepton/src/ParsedExpression.cpp +++ b/lib/colvars/lepton/src/ParsedExpression.cpp @@ -152,10 +152,10 @@ ExpressionTreeNode ParsedExpression::substituteSimplerExpression(const Expressio else children[i] = cached->second; } - + // Collect some info on constant expressions in children bool first_const = children.size() > 0 && isConstant(children[0]); // is first child constant? - bool second_const = children.size() > 1 && isConstant(children[1]); ; // is second child constant? + bool second_const = children.size() > 1 && isConstant(children[1]); ; // is second child constant? double first, second; // if yes, value of first and second child if (first_const) first = getConstantValue(children[0]); @@ -205,7 +205,7 @@ ExpressionTreeNode ParsedExpression::substituteSimplerExpression(const Expressio break; } case Operation::MULTIPLY: - { + { if ((first_const && first == 0.0) || (second_const && second == 0.0)) // Multiply by 0 return ExpressionTreeNode(new Operation::Constant(0.0)); if (first_const && first == 1.0) // Multiply by 1 diff --git a/lib/colvars/lepton/src/Parser.cpp b/lib/colvars/lepton/src/Parser.cpp index 47ebac464a..e284add258 100644 --- a/lib/colvars/lepton/src/Parser.cpp +++ b/lib/colvars/lepton/src/Parser.cpp @@ -66,7 +66,7 @@ private: string Parser::trim(const string& expression) { // Remove leading and trailing spaces. - + int start, end; for (start = 0; start < (int) expression.size() && isspace(expression[start]); start++) ; From 7a02043f18d58fcc7842798b0e1cfca06ed5e934 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 2 Jun 2022 12:11:10 -0400 Subject: [PATCH 293/585] update docs to list examples and include links to the tutorials --- doc/src/pair_sw_angle_table.rst | 224 +++++++++++++++-------------- doc/src/pair_threebody_table.rst | 237 +++++++++++++++++-------------- 2 files changed, 238 insertions(+), 223 deletions(-) diff --git a/doc/src/pair_sw_angle_table.rst b/doc/src/pair_sw_angle_table.rst index cc2bbba08f..6431917d67 100644 --- a/doc/src/pair_sw_angle_table.rst +++ b/doc/src/pair_sw_angle_table.rst @@ -20,7 +20,12 @@ Examples pair_style sw/angle/table pair_coeff * * spce.sw type - pair_coeff * * GaN.sw Ga N Ga + +Used in example input script: + + .. parsed-literal:: + + examples/PACKAGES/manybody_table/in.spce_sw Description @@ -47,27 +52,29 @@ system of atoms as where :math:`\phi_2` is a two-body term and :math:`\phi_3` is a three-body term. The summations in the formula are over all neighbors J -and K of atom I within a cutoff distance :math:`a \sigma`. -In contrast to the original *sw* style, *sw/angle/table* allows for a flexible -three-body term :math:`f^{\textrm{3b}}\left(\theta_{ijk}\right)` which is read in -as a tabulated interaction. It can be parameterized with the csg_fmatch app of VOTCA -as available at: https://gitlab.mpcdf.mpg.de/votca/votca. +and K of atom I within a cutoff distance :math:`a \sigma`. In contrast +to the original *sw* style, *sw/angle/table* allows for a flexible +three-body term :math:`f^{\textrm{3b}}\left(\theta_{ijk}\right)` which +is read in as a tabulated interaction. It can be parameterized with the +csg_fmatch app of VOTCA as available at: +https://gitlab.mpcdf.mpg.de/votca/votca. Only a single pair_coeff command is used with the *sw/angle/table* style -which specifies a modified Stillinger-Weber potential file with parameters for all -needed elements. These are mapped to LAMMPS atom types by specifying -N_el additional arguments after the ".sw" filename in the pair_coeff command, -where N_el is the number of LAMMPS atom types: +which specifies a modified Stillinger-Weber potential file with +parameters for all needed elements. These are mapped to LAMMPS atom +types by specifying N_el additional arguments after the ".sw" filename +in the pair_coeff command, where N_el is the number of LAMMPS atom +types: * ".sw" filename * N_el element names = mapping of SW elements to atom types -See the :doc:`pair_coeff ` page for alternate ways -to specify the path for the potential file. +See the :doc:`pair_coeff ` page for alternate ways to +specify the path for the potential file. -As an example, imagine a file SiC.sw has Stillinger-Weber values for -Si and C. If your LAMMPS simulation has 4 atoms types and you want -the first 3 to be Si, and the fourth to be C, you would use the following +As an example, imagine a file SiC.sw has Stillinger-Weber values for Si +and C. If your LAMMPS simulation has 4 atoms types and you want the +first 3 to be Si, and the fourth to be C, you would use the following pair_coeff command: .. code-block:: LAMMPS @@ -76,20 +83,20 @@ pair_coeff command: The first 2 arguments must be \* \* so as to span all LAMMPS atom types. The first three Si arguments map LAMMPS atom types 1,2,3 to the Si -element in the SW file. The final C argument maps LAMMPS atom type 4 -to the C element in the SW file. If a mapping value is specified as -NULL, the mapping is not performed. This can be used when a *sw/angle/table* +element in the SW file. The final C argument maps LAMMPS atom type 4 to +the C element in the SW file. If a mapping value is specified as NULL, +the mapping is not performed. This can be used when a *sw/angle/table* potential is used as part of the *hybrid* pair style. The NULL values -are placeholders for atom types that will be used with other -potentials. +are placeholders for atom types that will be used with other potentials. -The (modified) Stillinger-Weber files have a ".sw" suffix. Lines that are not blank or -comments (starting with #) define parameters for a triplet of -elements. The parameters in a single entry correspond to the two-body -and three-body coefficients in the formula above. Here, also the suffix -".sw" is used though the original Stillinger-Weber file format is supplemented -with four additional lines per parameter block to specify the tabulated -three-body interaction. A single entry then contains: +The (modified) Stillinger-Weber files have a ".sw" suffix. Lines that +are not blank or comments (starting with #) define parameters for a +triplet of elements. The parameters in a single entry correspond to the +two-body and three-body coefficients in the formula above. Here, also +the suffix ".sw" is used though the original Stillinger-Weber file +format is supplemented with four additional lines per parameter block to +specify the tabulated three-body interaction. A single entry then +contains: * element 1 (the center atom in a 3-body interaction) * element 2 @@ -111,11 +118,12 @@ three-body interaction. A single entry then contains: * N The A, B, p, and q parameters are used only for two-body interactions. -The :math:`\lambda` and :math:`\cos\theta_0` parameters, only used -for three-body interactions in the original Stillinger-Weber style, are read -in but ignored in this modified pair style. The :math:`\epsilon` parameter is only used -for two-body interactions in this modified pair style and not for the three-body -terms. The :math:`\sigma` and *a* parameters are used for both two-body and three-body +The :math:`\lambda` and :math:`\cos\theta_0` parameters, only used for +three-body interactions in the original Stillinger-Weber style, are read +in but ignored in this modified pair style. The :math:`\epsilon` +parameter is only used for two-body interactions in this modified pair +style and not for the three-body terms. The :math:`\sigma` and *a* +parameters are used for both two-body and three-body interactions. :math:`\gamma` is used only in the three-body interactions, but is defined for pairs of atoms. The non-annotated parameters are unitless. @@ -132,25 +140,25 @@ provides a *tol* value for each of the three-body entries so that they can be separately controlled. If tol = 0.0, then the standard Stillinger-Weber cutoff is used. -The additional parameters *filename*, *keyword*, *style*, and *N* refer to -the tabulated angular potential :math:`f^{\textrm{3b}}\left(\theta_{ijk}\right)`. -The tabulated angular potential has to be of the format as used in the -:doc:`angle_style table ` command: +The additional parameters *filename*, *keyword*, *style*, and *N* refer +to the tabulated angular potential +:math:`f^{\textrm{3b}}\left(\theta_{ijk}\right)`. The tabulated angular +potential has to be of the format as used in the :doc:`angle_style table +` command: -An interpolation tables of length *N* is created. The -interpolation is done in one of 2 *styles*: *linear* or *spline*. -For the *linear* style, the angle is used to find 2 surrounding table -values from which an energy or its derivative is computed by linear -interpolation. For the *spline* style, a cubic spline coefficients are computed and -stored at each of the *N* values in the table. The angle is used to -find the appropriate set of coefficients which are used to evaluate a -cubic polynomial which computes the energy or derivative. +An interpolation tables of length *N* is created. The interpolation is +done in one of 2 *styles*: *linear* or *spline*. For the *linear* +style, the angle is used to find 2 surrounding table values from which +an energy or its derivative is computed by linear interpolation. For the +*spline* style, a cubic spline coefficients are computed and stored at +each of the *N* values in the table. The angle is used to find the +appropriate set of coefficients which are used to evaluate a cubic +polynomial which computes the energy or derivative. The *filename* specifies the file containing the tabulated energy and derivative values of :math:`f^{\textrm{3b}}\left(\theta_{ijk}\right)`. -The *keyword* then specifies a section of the file. The -format of this file is as follows (without the -parenthesized comments): +The *keyword* then specifies a section of the file. The format of this +file is as follows (without the parenthesized comments): .. parsed-literal:: @@ -166,31 +174,30 @@ parenthesized comments): A section begins with a non-blank line whose first character is not a "#"; blank lines or lines starting with "#" can be used as comments -between sections. The first line begins with a keyword which -identifies the section. The next line lists (in any -order) one or more parameters for the table. Each parameter is a -keyword followed by one or more numeric values. +between sections. The first line begins with a keyword which identifies +the section. The next line lists (in any order) one or more parameters +for the table. Each parameter is a keyword followed by one or more +numeric values. The parameter "N" is required and its value is the number of table entries that follow. Note that this may be different than the *N* -specified in the Stillinger-Weber potential file. Let -Nsw = *N* in the ".sw" file, and Nfile = "N" in the -tabulated angular file. What LAMMPS does is a preliminary interpolation by -creating splines using the Nfile tabulated values as nodal points. It -uses these to interpolate as needed to generate energy and derivative -values at Ntable different points. The resulting tables of length -Nsw are then used as described above, when computing energy and -force for individual angles and their atoms. This means that if you -want the interpolation tables of length Nsw to match exactly what -is in the tabulated file (with effectively no preliminary -interpolation), you should set Nsw = Nfile. +specified in the Stillinger-Weber potential file. Let Nsw = *N* in the +".sw" file, and Nfile = "N" in the tabulated angular file. What LAMMPS +does is a preliminary interpolation by creating splines using the Nfile +tabulated values as nodal points. It uses these to interpolate as +needed to generate energy and derivative values at Ntable different +points. The resulting tables of length Nsw are then used as described +above, when computing energy and force for individual angles and their +atoms. This means that if you want the interpolation tables of length +Nsw to match exactly what is in the tabulated file (with effectively no +preliminary interpolation), you should set Nsw = Nfile. The "FP" parameter is optional. If used, it is followed by two values fplo and fphi, which are the second derivatives at the innermost and outermost angle settings. These values are needed by the spline -construction routines. If not specified by the "FP" parameter, they -are estimated (less accurately) by the first two and last two -derivative values in the table. +construction routines. If not specified by the "FP" parameter, they are +estimated (less accurately) by the first two and last two derivative +values in the table. The "EQ" parameter is also optional. If used, it is followed by a the equilibrium angle value, which is used, for example, by the :doc:`fix @@ -209,14 +216,15 @@ increase from one line to the next. The angle values must also begin with 0.0 and end with 180.0, i.e. span the full range of possible angles. -Note that one angular potential file can contain many sections, each with a tabulated -potential. LAMMPS reads the file section by section until it finds -one that matches the specified *keyword* of appropriate section of the ".sw" file. +Note that one angular potential file can contain many sections, each +with a tabulated potential. LAMMPS reads the file section by section +until it finds one that matches the specified *keyword* of appropriate +section of the ".sw" file. The Stillinger-Weber potential file must contain entries for all the -elements listed in the pair_coeff command. It can also contain -entries for additional elements not being used in a particular -simulation; LAMMPS ignores those entries. +elements listed in the pair_coeff command. It can also contain entries +for additional elements not being used in a particular simulation; +LAMMPS ignores those entries. For a single-element simulation, only a single entry is required (e.g. SiSiSi). For a two-element simulation, the file must contain 8 @@ -225,40 +233,31 @@ specify SW parameters for all permutations of the two elements interacting in three-body configurations. Thus for 3 elements, 27 entries would be required, etc. -As annotated above, the first element in the entry is the center atom -in a three-body interaction. Thus an entry for SiCC means a Si atom -with 2 C atoms as neighbors. The parameter values used for the -two-body interaction come from the entry where the second and third -elements are the same. Thus the two-body parameters for Si -interacting with C, comes from the SiCC entry. The three-body -angular potential :math:`f^{\textrm{3b}}\left(\theta_{ijk}\right)` -can in principle be specific to the three elements of the -configuration. However, the user must ensure that it makes physically sense. -Note also that the function :math:`\phi_3` contains two exponential -screening factors with parameter values from the ij pair and ik -pairs. So :math:`\phi_3` for a C atom bonded to a Si atom and a second C atom -will depend on the three-body parameters for the CSiC entry, and also -on the two-body parameters for the CCC and CSiSi entries. Since the -order of the two neighbors is arbitrary, the three-body parameters -and the tabulated angular potential for -entries CSiC and CCSi should be the same. Similarly, the two-body +As annotated above, the first element in the entry is the center atom in +a three-body interaction. Thus an entry for SiCC means a Si atom with 2 +C atoms as neighbors. The parameter values used for the two-body +interaction come from the entry where the second and third elements are +the same. Thus the two-body parameters for Si interacting with C, comes +from the SiCC entry. The three-body angular potential +:math:`f^{\textrm{3b}}\left(\theta_{ijk}\right)` can in principle be +specific to the three elements of the configuration. However, the user +must ensure that it makes physically sense. Note also that the function +:math:`\phi_3` contains two exponential screening factors with parameter +values from the ij pair and ik pairs. So :math:`\phi_3` for a C atom +bonded to a Si atom and a second C atom will depend on the three-body +parameters for the CSiC entry, and also on the two-body parameters for +the CCC and CSiSi entries. Since the order of the two neighbors is +arbitrary, the three-body parameters and the tabulated angular potential +for entries CSiC and CCSi should be the same. Similarly, the two-body parameters for entries SiCC and CSiSi should also be the same. The parameters used only for two-body interactions (A, B, p, and q) in -entries whose second and third element are different (e.g. SiCSi) are not -used for anything and can be set to 0.0 if desired. -This is also true for the parameters in :math:`\phi_3` that are -taken from the ij and ik pairs (:math:`\sigma`, *a*, :math:`\gamma`) +entries whose second and third element are different (e.g. SiCSi) are +not used for anything and can be set to 0.0 if desired. This is also +true for the parameters in :math:`\phi_3` that are taken from the ij and +ik pairs (:math:`\sigma`, *a*, :math:`\gamma`) ----------- - -.. include:: accel_styles.rst - -.. note:: - - When using the INTEL package with this style, there is an additional - 5 to 10 percent performance improvement when the Stillinger-Weber - parameters p and q are set to 4 and 0 respectively. These - parameters are common for modeling silicon and water. +Additional input files and reference data can be found at: +https://gitlab.mpcdf.mpg.de/votca/votca/-/tree/master/csg-tutorials/spce/3body_sw ---------- @@ -266,16 +265,17 @@ Mixing, shift, table, tail correction, restart, rRESPA info """"""""""""""""""""""""""""""""""""""""""""""""""""""""""" For atom type pairs I,J and I != J, where types I and J correspond to -two different element types, mixing is performed by LAMMPS as -described above from values in the potential file, but not for the -tabulated angular potential file. +two different element types, mixing is performed by LAMMPS as described +above from values in the potential file, but not for the tabulated +angular potential file. This pair style does not support the :doc:`pair_modify ` shift, table, and tail options. -This pair style does not write its information to :doc:`binary restart files `, since it is stored in potential files. -Thus, you need to re-specify the pair_style and pair_coeff commands in an input -script that reads a restart file. +This pair style does not write its information to :doc:`binary restart +files `, since it is stored in potential files. Thus, you need +to re-specify the pair_style and pair_coeff commands in an input script +that reads a restart file. This pair style can only be used via the *pair* keyword of the :doc:`run_style respa ` command. It does not support the @@ -286,15 +286,13 @@ This pair style can only be used via the *pair* keyword of the Restrictions """""""""""" -This is a user pair style. For more information, see :ref:`Scherer1 -`. It is only enabled if LAMMPS was explicitly built with it. +This pair style is part of the MANYBODY package. It is only enabled if +LAMMPS was built with that package. See the :doc:`Build package +` page for more info. This pair style requires the :doc:`newton ` setting to be "on" for pair interactions. -For an example of an extended Stillinger-Weber potential file, have a look at the tutorial -in the tutorial folder. - Related commands """""""""""""""" diff --git a/doc/src/pair_threebody_table.rst b/doc/src/pair_threebody_table.rst index 5e2503fc3f..68661270c9 100644 --- a/doc/src/pair_threebody_table.rst +++ b/doc/src/pair_threebody_table.rst @@ -19,18 +19,28 @@ Examples .. code-block:: LAMMPS pair_style threebody/table - pair_coeff * * spce.3b type - pair_coeff * * GaN.3b Ga N Ga + pair_coeff * * spce2.3b type1 type2 + pair_style hybrid/overlay table linear 1200 threebody/table + pair_coeff 1 1 table table_CG_CG.txt VOTCA + pair_coeff * * threebody/table spce.3b type + +Used in example input scripts: + + .. parsed-literal:: + + examples/PACKAGES/manybody_table/in.spce + examples/PACKAGES/manybody_table/in.spce2 Description """"""""""" -The *threebody/table* style is a pair style for generic tabulated three-body -interactions. It has been developed for (coarse-grained) simulations -(of water) with Kernel-based machine learning (ML) potentials -(:ref:`Scherer2 `). As for many other MANYBODY package pair styles -the energy of a system is computed as a sum over three-body terms: +The *threebody/table* style is a pair style for generic tabulated +three-body interactions. It has been developed for (coarse-grained) +simulations (of water) with Kernel-based machine learning (ML) +potentials (:ref:`Scherer2 `). As for many other MANYBODY +package pair styles the energy of a system is computed as a sum over +three-body terms: .. math:: @@ -40,24 +50,25 @@ The summations in the formula are over all neighbors J and K of atom I within a cutoff distance :math:`cut`. In contrast to the Stillinger-Weber potential, all forces are not calculated analytically, but read in from a three-body force/energy table which can be generated -with the csg_ml app of VOTCA as available at: https://gitlab.mpcdf.mpg.de/votca/votca. +with the csg_ml app of VOTCA as available at: +https://gitlab.mpcdf.mpg.de/votca/votca. -Only a single pair_coeff command is used with the *threebody/table* style -which specifies a threebody potential (".3b") file with parameters for all -needed elements. These are then mapped to LAMMPS atom types by specifying -N_el additional arguments after the ".3b" filename in the pair_coeff command, -where N_el is the number of LAMMPS atom types: +Only a single pair_coeff command is used with the *threebody/table* +style which specifies a threebody potential (".3b") file with parameters +for all needed elements. These are then mapped to LAMMPS atom types by +specifying N_el additional arguments after the ".3b" filename in the +pair_coeff command, where N_el is the number of LAMMPS atom types: * ".3b" filename * N_el element names = mapping of threebody elements to atom types -See the :doc:`pair_coeff ` page for alternate ways -to specify the path for the potential file. +See the :doc:`pair_coeff ` page for alternate ways to +specify the path for the potential file. -As an example, imagine a file SiC.3b has three-body values for -Si and C. If your LAMMPS simulation has 4 atoms types and you want -the first 3 to be Si, and the fourth to be C, you would use the following -pair_coeff command: +As an example, imagine a file SiC.3b has three-body values for Si and C. +If your LAMMPS simulation has 4 atoms types and you want the first 3 to +be Si, and the fourth to be C, you would use the following pair_coeff +command: .. code-block:: LAMMPS @@ -66,17 +77,17 @@ pair_coeff command: The first 2 arguments must be \* \* so as to span all LAMMPS atom types. The first three Si arguments map LAMMPS atom types 1,2,3 to the Si element in the ".3b" file. The final C argument maps LAMMPS atom type 4 -to the C element in the threebody file. If a mapping value is specified as -NULL, the mapping is not performed. This can be used when a *threebody/table* -potential is used as part of the *hybrid* pair style. The NULL values -are placeholders for atom types that will be used with other -potentials. +to the C element in the threebody file. If a mapping value is specified +as NULL, the mapping is not performed. This can be used when a +*threebody/table* potential is used as part of the *hybrid* pair style. +The NULL values are placeholders for atom types that will be used with +other potentials. The three-body files have a ".3b" suffix. Lines that are not blank or comments (starting with #) define parameters for a triplet of -elements. The parameters in a single entry specify to the -(three-body) cutoff distance and the tabulated -three-body interaction. A single entry then contains: +elements. The parameters in a single entry specify to the (three-body) +cutoff distance and the tabulated three-body interaction. A single entry +then contains: * element 1 (the center atom in a 3-body interaction) * element 2 @@ -87,33 +98,33 @@ three-body interaction. A single entry then contains: * style * N -The parameter :math:`cut` is the (three-body) cutoff distance. -When set to 0, no interaction is calculated for this element triplet. -The parameters *filename*, *keyword*, *style*, and *N* refer to -the tabulated three-body potential. +The parameter :math:`cut` is the (three-body) cutoff distance. When set +to 0, no interaction is calculated for this element triplet. The +parameters *filename*, *keyword*, *style*, and *N* refer to the +tabulated three-body potential. The tabulation is done on a three-dimensional grid of the two distances -:math:`r_{ij}` and :math:`r_{ik}` as well as the angle :math:`\theta_{ijk}` -which is constructed in the following way. There are two different cases. -If element 2 and element 3 are of the same type (e.g. SiCC), the distance -:math:`r_{ij}` is varied in "N" steps from rmin to rmax and the distance -:math:`r_{ik}` is varied from :math:`r_{ij}` to rmax. This can be done, -due to the symmetry of the triplet. If element 2 and element 3 are not -of the same type (e.g. SiCSi), there is no additional symmetry and the -distance :math:`r_{ik}` is also varied from rmin to rmax in "N" steps. -The angle :math:`\theta_{ijk}` is always varied in "2N" steps from -(0.0 + 180.0/(4N)) to (180.0 - 180.0/(4N)). Therefore, the total number -of table entries is "M = N * N * (N+1)" for the symmetric (element 2 and element 3 -are of the same type) and "M = 2 * N * N * N" for the general case -(element 2 and element 3 are not of the same type). +:math:`r_{ij}` and :math:`r_{ik}` as well as the angle +:math:`\theta_{ijk}` which is constructed in the following way. There +are two different cases. If element 2 and element 3 are of the same +type (e.g. SiCC), the distance :math:`r_{ij}` is varied in "N" steps +from rmin to rmax and the distance :math:`r_{ik}` is varied from +:math:`r_{ij}` to rmax. This can be done, due to the symmetry of the +triplet. If element 2 and element 3 are not of the same type +(e.g. SiCSi), there is no additional symmetry and the distance +:math:`r_{ik}` is also varied from rmin to rmax in "N" steps. The angle +:math:`\theta_{ijk}` is always varied in "2N" steps from (0.0 + +180.0/(4N)) to (180.0 - 180.0/(4N)). Therefore, the total number of +table entries is "M = N * N * (N+1)" for the symmetric (element 2 and +element 3 are of the same type) and "M = 2 * N * N * N" for the general +case (element 2 and element 3 are not of the same type). -The forces on all three particles I, J, and K of a triplet -of this type of three-body interaction potential -(:math:`\phi_3 (r_{ij}, r_{ik}, \theta_{ijk})`) lie within -the plane defined by the three inter-particle distance vectors -:math:`{\mathbf r}_{ij}`, :math:`{\mathbf r}_{ik}`, and :math:`{\mathbf r}_{jk}`. -This property is used to project the forces onto the inter-particle -distance vectors as follows +The forces on all three particles I, J, and K of a triplet of this type +of three-body interaction potential (:math:`\phi_3 (r_{ij}, r_{ik}, +\theta_{ijk})`) lie within the plane defined by the three inter-particle +distance vectors :math:`{\mathbf r}_{ij}`, :math:`{\mathbf r}_{ik}`, and +:math:`{\mathbf r}_{jk}`. This property is used to project the forces +onto the inter-particle distance vectors as follows .. math:: @@ -133,18 +144,18 @@ distance vectors as follows {\mathbf r}_{jk} \\ \end{pmatrix} -and then tabulate the 6 force constants :math:`f_{i1}`, :math:`f_{i2}`, :math:`f_{j1}`, -:math:`f_{j2}`, :math:`f_{k1}`, and :math:`f_{k2}`, as well as the energy of a triplet e. -Due to symmetry reasons, the following relations hold: :math:`f_{i1}=-f_{j1}`, -:math:`f_{i2}=-f_{k1}`, and :math:`f_{j2}=-f_{k2}`. As in this pair style the -forces are read in directly, a correct MD simulation is also performed in the case that -the triplet energies are set to e=0. +and then tabulate the 6 force constants :math:`f_{i1}`, :math:`f_{i2}`, +:math:`f_{j1}`, :math:`f_{j2}`, :math:`f_{k1}`, and :math:`f_{k2}`, as +well as the energy of a triplet e. Due to symmetry reasons, the +following relations hold: :math:`f_{i1}=-f_{j1}`, +:math:`f_{i2}=-f_{k1}`, and :math:`f_{j2}=-f_{k2}`. As in this pair +style the forces are read in directly, a correct MD simulation is also +performed in the case that the triplet energies are set to e=0. The *filename* specifies the file containing the tabulated energy and -derivative values of :math:`\phi_3 (r_{ij}, r_{ik}, \theta_{ijk})`. -The *keyword* then specifies a section of the file. The -format of this file is as follows (without the -parenthesized comments): +derivative values of :math:`\phi_3 (r_{ij}, r_{ik}, \theta_{ijk})`. The +*keyword* then specifies a section of the file. The format of this file +is as follows (without the parenthesized comments): .. parsed-literal:: @@ -160,45 +171,51 @@ parenthesized comments): A section begins with a non-blank line whose first character is not a "#"; blank lines or lines starting with "#" can be used as comments -between sections. The first line begins with a keyword which -identifies the section. The next line lists (in any -order) one or more parameters for the table. Each parameter is a -keyword followed by one or more numeric values. +between sections. The first line begins with a keyword which identifies +the section. The next line lists (in any order) one or more parameters +for the table. Each parameter is a keyword followed by one or more +numeric values. -The parameter "N" is required. It should be the same than the parameter "N" of the ".3b" file, -otherwise its value is overwritten. "N" determines the number of table -entries "M" that follow: "M = N * N * (N+1)" (symmetric triplet, e.g. SiCC) or -"M = 2 * N * N * N" (asymmetric triplet, e.g. SiCSi). Therefore "M = 12 * 12 * 13 = 1872" -in the above symmetric example. The parameters "rmin" and "rmax" are also required +The parameter "N" is required. It should be the same than the parameter +"N" of the ".3b" file, otherwise its value is overwritten. "N" +determines the number of table entries "M" that follow: "M = N * N * +(N+1)" (symmetric triplet, e.g. SiCC) or "M = 2 * N * N * N" (asymmetric +triplet, e.g. SiCSi). Therefore "M = 12 * 12 * 13 = 1872" in the above +symmetric example. The parameters "rmin" and "rmax" are also required and determine the minimum and maximum of the inter-particle distances :math:`r_{ij}` and :math:`r_{ik}`. -Following a blank line, the next M lines of the angular table file list the tabulated values. -On each line, the first value is the index from 1 to M, the second value is the distance -:math:`r_{ij}`, the third value is the distance :math:`r_{ik}`, the fourth value -is the angle :math:`\theta_{ijk})`, the next six values are the force constants :math:`f_{i1}`, -:math:`f_{i2}`, :math:`f_{j1}`, :math:`f_{j2}`, :math:`f_{k1}`, and :math:`f_{k2}`, and the -last value is the energy e. +Following a blank line, the next M lines of the angular table file list +the tabulated values. On each line, the first value is the index from 1 +to M, the second value is the distance :math:`r_{ij}`, the third value +is the distance :math:`r_{ik}`, the fourth value is the angle +:math:`\theta_{ijk})`, the next six values are the force constants +:math:`f_{i1}`, :math:`f_{i2}`, :math:`f_{j1}`, :math:`f_{j2}`, +:math:`f_{k1}`, and :math:`f_{k2}`, and the last value is the energy e. -Note that one three-body potential file can contain many sections, each with a tabulated -potential. LAMMPS reads the file section by section until it finds -one that matches the specified *keyword* of appropriate section of the ".3b" file. +Note that one three-body potential file can contain many sections, each +with a tabulated potential. LAMMPS reads the file section by section +until it finds one that matches the specified *keyword* of appropriate +section of the ".3b" file. -At the moment, only the *style* *linear* is allowed and implemented. After reading in the -force table, it is internally stored in LAMMPS as a lookup table. For each triplet -configuration occurring in the simulation within the cutoff distance, -the next nearest tabulated triplet configuration is looked up. No interpolation is done. -This allows for a very efficient force calculation -with the stored force constants and energies. Due to the know table structure, the lookup -can be done efficiently. It has been tested (:ref:`Scherer2 `) that with a reasonably -small bin size, the accuracy and speed is comparable to that of a Stillinger-Weber potential -with tabulated three-body interactions (:doc:`pair_style sw/angle/table `) while -the table format of this pair style allows for more flexible three-body interactions. +At the moment, only the *style* *linear* is allowed and +implemented. After reading in the force table, it is internally stored +in LAMMPS as a lookup table. For each triplet configuration occurring in +the simulation within the cutoff distance, the next nearest tabulated +triplet configuration is looked up. No interpolation is done. This +allows for a very efficient force calculation with the stored force +constants and energies. Due to the know table structure, the lookup can +be done efficiently. It has been tested (:ref:`Scherer2 `) +that with a reasonably small bin size, the accuracy and speed is +comparable to that of a Stillinger-Weber potential with tabulated +three-body interactions (:doc:`pair_style sw/angle/table +`) while the table format of this pair style allows +for more flexible three-body interactions. -As for the Stillinger-Weber potential, the three-body potential file must contain entries for all the -elements listed in the pair_coeff command. It can also contain -entries for additional elements not being used in a particular -simulation; LAMMPS ignores those entries. +As for the Stillinger-Weber potential, the three-body potential file +must contain entries for all the elements listed in the pair_coeff +command. It can also contain entries for additional elements not being +used in a particular simulation; LAMMPS ignores those entries. For a single-element simulation, only a single entry is required (e.g. SiSiSi). For a two-element simulation, the file must contain 8 @@ -207,16 +224,17 @@ specify threebody parameters for all permutations of the two elements interacting in three-body configurations. Thus for 3 elements, 27 entries would be required, etc. -As annotated above, the first element in the entry is the center atom -in a three-body interaction. Thus an entry for SiCC means a Si atom -with 2 C atoms as neighbors. The tabulated three-body forces can in -principle be specific to the three elements of the configuration. -However, the user must ensure that it makes physically sense. -E.g., the tabulated three-body forces for the -entries CSiC and CCSi should be the same exchanging :math:`r_{ij}` with -r_{ik}, :math:`f_{j1}` with :math:`f_{k1}`, -and :math:`f_{j2}` with :math:`f_{k2}`. +As annotated above, the first element in the entry is the center atom in +a three-body interaction. Thus an entry for SiCC means a Si atom with 2 +C atoms as neighbors. The tabulated three-body forces can in principle +be specific to the three elements of the configuration. However, the +user must ensure that it makes physically sense. E.g., the tabulated +three-body forces for the entries CSiC and CCSi should be the same +exchanging :math:`r_{ij}` with r_{ik}, :math:`f_{j1}` with +:math:`f_{k1}`, and :math:`f_{j2}` with :math:`f_{k2}`. +Additional input files and reference data can be found at: +https://gitlab.mpcdf.mpg.de/votca/votca/-/tree/master/csg-tutorials/ml ---------- @@ -228,9 +246,10 @@ As all interactions are tabulated, no mixing is performed. This pair style does not support the :doc:`pair_modify ` shift, table, and tail options. -This pair style does not write its information to :doc:`binary restart files `, since it is stored in potential files. -Thus, you need to re-specify the pair_style and pair_coeff commands in an input -script that reads a restart file. +This pair style does not write its information to :doc:`binary restart +files `, since it is stored in potential files. Thus, you need +to re-specify the pair_style and pair_coeff commands in an input script +that reads a restart file. This pair style can only be used via the *pair* keyword of the :doc:`run_style respa ` command. It does not support the @@ -241,15 +260,13 @@ This pair style can only be used via the *pair* keyword of the Restrictions """""""""""" -This is a user pair style. For more information, see :ref:`Scherer2 `. It is only enabled -if LAMMPS was explicitly built with it. +This pair style is part of the MANYBODY package. It is only enabled if +LAMMPS was built with that package. See the :doc:`Build package +` page for more info. This pair style requires the :doc:`newton ` setting to be "on" for pair interactions. -For an example of a three-body potential file, have a look at the tutorial -in the tutorial folder. - Related commands """""""""""""""" From 2742517a4f0aa0eb272b4dd2e8158a38b40c4723 Mon Sep 17 00:00:00 2001 From: Olav Galteland Date: Thu, 2 Jun 2022 18:26:09 +0200 Subject: [PATCH 294/585] Clean up of stress/cartesian --- .../compute_stress_cartesian.cpp | 146 ++++-------------- src/EXTRA-COMPUTE/compute_stress_cartesian.h | 24 ++- 2 files changed, 51 insertions(+), 119 deletions(-) diff --git a/src/EXTRA-COMPUTE/compute_stress_cartesian.cpp b/src/EXTRA-COMPUTE/compute_stress_cartesian.cpp index 5a92f6c347..3385002fb8 100644 --- a/src/EXTRA-COMPUTE/compute_stress_cartesian.cpp +++ b/src/EXTRA-COMPUTE/compute_stress_cartesian.cpp @@ -80,21 +80,23 @@ ComputeStressCartesian::ComputeStressCartesian(LAMMPS *lmp, int narg, char **arg dir2 = 0; bin_width1 = utils::numeric(FLERR, arg[4], false, lmp); - bin_width2 = 0.0; + bin_width2 = domain->boxhi[dir2]-domain->boxlo[dir2]; nbins1 = (int) ((domain->boxhi[dir1] - domain->boxlo[dir1]) / bin_width1); nbins2 = 1; + // adjust bin width if not a perfect match - invV = (domain->boxhi[dir1] - domain->boxlo[dir1]) / nbins1; - if ((fabs(invV - bin_width1) > SMALL) && (comm->me == 0)) - utils::logmesg(lmp, "Adjusting first bin width for compute {} from {:.6f} to {:.6f}\n", style, - bin_width1, invV); - bin_width1 = invV; + double tmp_binwidth = (domain->boxhi[dir1] - domain->boxlo[dir1]) / nbins1; + if ((fabs(tmp_binwidth - bin_width1) > SMALL) && (comm->me == 0)) + utils::logmesg(lmp, "Adjusting second bin width for compute {} from {:.6f} to {:.6f}\n", + style, bin_width1, tmp_binwidth); + bin_width1 = tmp_binwidth; if (bin_width1 <= 0.0) error->all(FLERR, "Illegal compute stress/cartesian command. Bin width must be > 0"); else if (bin_width1 > domain->boxhi[dir1] - domain->boxlo[dir1]) error->all(FLERR, "Illegal compute stress/cartesian command. Bin width larger than box."); - + + invV = bin_width1; if (dims == 2) { if (strcmp(arg[5], "x") == 0) dir2 = 0; @@ -107,7 +109,9 @@ ComputeStressCartesian::ComputeStressCartesian(LAMMPS *lmp, int narg, char **arg bin_width2 = utils::numeric(FLERR, arg[6], false, lmp); nbins2 = (int) ((domain->boxhi[dir2] - domain->boxlo[dir2]) / bin_width2); - double tmp_binwidth = (domain->boxhi[dir2] - domain->boxlo[dir2]) / nbins2; + + // adjust bin width if not a perfect match + tmp_binwidth = (domain->boxhi[dir2] - domain->boxlo[dir2]) / nbins2; if ((fabs(tmp_binwidth - bin_width2) > SMALL) && (comm->me == 0)) utils::logmesg(lmp, "Adjusting second bin width for compute {} from {:.6f} to {:.6f}\n", style, bin_width2, tmp_binwidth); @@ -132,6 +136,9 @@ ComputeStressCartesian::ComputeStressCartesian(LAMMPS *lmp, int narg, char **arg size_array_cols = 7 + dims; // dir1, dir2, number density, pkxx, pkyy, pkzz, pcxx, pcyy, pczz size_array_rows = nbins1 * nbins2; + memory->create(v0x, nbins1 * nbins2, "v0x"); + memory->create(v0y, nbins1 * nbins2, "v0y"); + memory->create(v0z, nbins1 * nbins2, "v0z"); memory->create(dens, nbins1 * nbins2, "dens"); memory->create(pkxx, nbins1 * nbins2, "pkxx"); memory->create(pkyy, nbins1 * nbins2, "pkyy"); @@ -154,6 +161,9 @@ ComputeStressCartesian::ComputeStressCartesian(LAMMPS *lmp, int narg, char **arg ComputeStressCartesian::~ComputeStressCartesian() { memory->destroy(dens); + memory->destroy(v0x); + memory->destroy(v0y); + memory->destroy(v0z); memory->destroy(pkxx); memory->destroy(pkyy); memory->destroy(pkzz); @@ -230,6 +240,9 @@ void ComputeStressCartesian::compute_array() // Zero arrays for (bin = 0; bin < nbins1 * nbins2; bin++) { tdens[bin] = 0; + v0x[bin] = 0; + v0y[bin] = 0; + v0z[bin] = 0; tpkxx[bin] = 0; tpkyy[bin] = 0; tpkzz[bin] = 0; @@ -237,7 +250,7 @@ void ComputeStressCartesian::compute_array() tpcyy[bin] = 0; tpczz[bin] = 0; } - + // calculate number density and kinetic contribution to pressure for (i = 0; i < nlocal; i++) { bin1 = (int) (x[i][dir1] / bin_width1) % nbins1; @@ -246,9 +259,9 @@ void ComputeStressCartesian::compute_array() j = bin1 + bin2 * nbins1; tdens[j] += 1; - tpkxx[j] += mass[type[i]] * v[i][0] * v[i][0]; - tpkyy[j] += mass[type[i]] * v[i][1] * v[i][1]; - tpkzz[j] += mass[type[i]] * v[i][2] * v[i][2]; + tpkxx[j] += mass[type[i]] * (v[i][0]-v0x[j]) * (v[i][0]-v0x[j]); + tpkyy[j] += mass[type[i]] * (v[i][1]-v0y[j]) * (v[i][1]-v0y[j]); + tpkzz[j] += mass[type[i]] * (v[i][2]-v0z[j]) * (v[i][2]-v0z[j]); } // loop over neighbors of my atoms @@ -314,8 +327,7 @@ void ComputeStressCartesian::compute_array() // Check if inside cut-off if (rsq >= cutsq[itype][jtype]) continue; pair->single(i, j, itype, jtype, rsq, factor_coul, factor_lj, fpair); - if (dims == 1) compute_pressure_1d(fpair, xi1, xj1, delx, dely, delz); - if (dims == 2) compute_pressure_2d(fpair, xi1, xi2, xj1, xj2, delx, dely, delz); + compute_pressure(fpair, xi1, xi2, xj1, xj2, delx, dely, delz); } } @@ -353,107 +365,9 @@ void ComputeStressCartesian::compute_array() } } -void ComputeStressCartesian::compute_pressure_1d(double fpair, double xi, double xj, double delx, - double dely, double delz) -{ - int bin_s, bin_e, bin_step, bin, bin_limit; - double xa, xb; - if (xi < domain->boxlo[dir1]) - xi += (domain->boxhi[dir1] - domain->boxlo[dir1]); - else if (xi > domain->boxhi[dir1]) - xi -= (domain->boxhi[dir1] - domain->boxlo[dir1]); - if (xj < domain->boxlo[dir1]) - xj += (domain->boxhi[dir1] - domain->boxlo[dir1]); - else if (xj > domain->boxhi[dir1]) - xj -= (domain->boxhi[dir1] - domain->boxlo[dir1]); - - // Integrating contour from bin_s to bin_e - bin_s = ((int) lround((xi - domain->boxlo[dir1]) / bin_width1)) % nbins1; - bin_e = ((int) lround((xj - domain->boxlo[dir1]) / bin_width1)) % nbins1; - - // If not periodic in dir1 - if (domain->periodicity[dir1] == 0) { - bin_s = ((int) lround((xi - domain->boxlo[dir1]) / bin_width1)); - bin_e = ((int) lround((xj - domain->boxlo[dir1]) / bin_width1)); - - if (bin_e == nbins1) bin_e--; - if (bin_s == nbins1) bin_s--; - } - - bin_step = 1; - if (domain->periodicity[dir1] == 1) { - if (bin_e - bin_s > 0.5 * nbins1) - bin_step = -1; - else if (bin_s - bin_e > 0.5 * nbins1) - bin_step = 1; - else if (bin_s > bin_e) - bin_step = -1; - } else { - if (bin_s > bin_e) bin_step = -1; - } - if (domain->periodicity[dir1] == 1) - bin_limit = (bin_e + bin_step) % nbins1 < 0 ? (bin_e + bin_step) % nbins1 + nbins1 - : (bin_e + bin_step) % nbins1; - else - bin_limit = bin_e + bin_step; - - bin = bin_s; - // Integrate from bin_s to bin_e with step bin_step. - while (bin < bin_limit) { - - // Calculating exit and entry point (xa, xb). Checking if inside current bin. - if (bin == bin_s) { - if (domain->periodicity[dir1] == 1) - xa = fmod(xi, domain->boxhi[dir1]) + domain->boxlo[dir1]; - else - xa = xi; - } else - xa = (bin_step == 1) ? bin * bin_width1 : (bin + 1) * bin_width1; - if (bin == bin_e) { - if (domain->periodicity[dir1] == 1) - xb = fmod(xj, domain->boxhi[dir1]) + domain->boxlo[dir1]; - else - xb = xj; - } else - xb = (bin_step == 1) ? (bin + 1) * bin_width1 : bin * bin_width1; - - if (bin < 0 || bin >= nbins1) error->all(FLERR, "ERROR: Bin outside simulation."); - - if (bin_s != bin_e) { - if (dir1 == 0) { - tpcxx[bin] += (fpair * delx * delx) * (xb - xa) / delx; - tpcyy[bin] += (fpair * dely * dely) * (xb - xa) / delx; - tpczz[bin] += (fpair * delz * delz) * (xb - xa) / delx; - } else if (dir1 == 1) { - tpcxx[bin] += (fpair * delx * delx) * (xb - xa) / dely; - tpcyy[bin] += (fpair * dely * dely) * (xb - xa) / dely; - tpczz[bin] += (fpair * delz * delz) * (xb - xa) / dely; - } else if (dir1 == 2) { - tpcxx[bin] += (fpair * delx * delx) * (xb - xa) / delz; - tpcyy[bin] += (fpair * dely * dely) * (xb - xa) / delz; - tpczz[bin] += (fpair * delz * delz) * (xb - xa) / delz; - } - } - // Particle i and j in same bin. Avoiding zero divided by zero. - else { - tpcxx[bin] += fpair * delx * delx; - tpcyy[bin] += fpair * dely * dely; - tpczz[bin] += fpair * delz * delz; - } - - // Stepping bin to next bin - if (domain->periodicity[dir1] == 1) - bin = (bin + bin_step) % nbins1 < 0 ? (bin + bin_step) % nbins1 + nbins1 - : (bin + bin_step) % nbins1; - else - bin = bin + bin_step; - } -} - -void ComputeStressCartesian::compute_pressure_2d(double fpair, double xi, double yi, double /*xj*/, - double /*yj*/, double delx, double dely, - double delz) +void ComputeStressCartesian::compute_pressure(double fpair, double xi, double yi, double xj, + double yj, double delx, double dely, double delz) { int bin1, bin2, next_bin1, next_bin2; double la = 0.0, lb = 0.0, l_sum = 0.0; @@ -464,7 +378,7 @@ void ComputeStressCartesian::compute_pressure_2d(double fpair, double xi, double next_bin1 = (int) floor(xi / bin_width1); next_bin2 = (int) floor(yi / bin_width2); - + // Integrating along line while (lb < 1.0) { bin1 = next_bin1; @@ -529,5 +443,5 @@ memory usage of data double ComputeStressCartesian::memory_usage() { - return (14.0 + dims + 7) * (double) (nbins1 * nbins2) * sizeof(double); + return (14.0 + dims + 10) * (double) (nbins1 * nbins2) * sizeof(double); } diff --git a/src/EXTRA-COMPUTE/compute_stress_cartesian.h b/src/EXTRA-COMPUTE/compute_stress_cartesian.h index 30ddc8e45e..0478e08b93 100644 --- a/src/EXTRA-COMPUTE/compute_stress_cartesian.h +++ b/src/EXTRA-COMPUTE/compute_stress_cartesian.h @@ -38,14 +38,32 @@ class ComputeStressCartesian : public Compute { double bin_width1, bin_width2, invV; // Number density, kinetic and configurational contribution to the pressure. - double *dens, *pkxx, *pkyy, *pkzz, *pcxx, *pcyy, *pczz; + double *v0x, *v0y, *v0z, *dens, *pkxx, *pkyy, *pkzz, *pcxx, *pcyy, *pczz; double *tdens, *tpkxx, *tpkyy, *tpkzz, *tpcxx, *tpcyy, *tpczz; class NeighList *list; - void compute_pressure_1d(double, double, double, double, double, double); - void compute_pressure_2d(double, double, double, double, double, double, double, double); + void compute_pressure(double, double, double, double, double, double, double, double); }; } // namespace LAMMPS_NS #endif #endif + +/* ERROR/WARNING messages: + +E: Illegal ... command + +Self-explanatory. Check the input script syntax and compare to the +documentation for the command. You can use -echo screen as a +command-line option when running LAMMPS to see the offending line. + +E: No pair style is defined for compute stress/cartesian + +Self-explanatory. + +E: Pair style does not support compute stress/cartesian + +The pair style does not have a single() function, so it can +not be invoked by compute stress/cartesian. + +*/ From 954700dea5cadf0b2217da31d558d99b10b487be Mon Sep 17 00:00:00 2001 From: Olav Galteland Date: Thu, 2 Jun 2022 18:28:04 +0200 Subject: [PATCH 295/585] Updated memory calculation and removed unused variables --- src/EXTRA-COMPUTE/compute_stress_cartesian.cpp | 2 +- src/EXTRA-COMPUTE/compute_stress_cartesian.h | 2 +- 2 files changed, 2 insertions(+), 2 deletions(-) diff --git a/src/EXTRA-COMPUTE/compute_stress_cartesian.cpp b/src/EXTRA-COMPUTE/compute_stress_cartesian.cpp index 3385002fb8..a52779ebdd 100644 --- a/src/EXTRA-COMPUTE/compute_stress_cartesian.cpp +++ b/src/EXTRA-COMPUTE/compute_stress_cartesian.cpp @@ -443,5 +443,5 @@ memory usage of data double ComputeStressCartesian::memory_usage() { - return (14.0 + dims + 10) * (double) (nbins1 * nbins2) * sizeof(double); + return (14.0 + dims + 7) * (double) (nbins1 * nbins2) * sizeof(double); } diff --git a/src/EXTRA-COMPUTE/compute_stress_cartesian.h b/src/EXTRA-COMPUTE/compute_stress_cartesian.h index 0478e08b93..1aa7f34f6e 100644 --- a/src/EXTRA-COMPUTE/compute_stress_cartesian.h +++ b/src/EXTRA-COMPUTE/compute_stress_cartesian.h @@ -38,7 +38,7 @@ class ComputeStressCartesian : public Compute { double bin_width1, bin_width2, invV; // Number density, kinetic and configurational contribution to the pressure. - double *v0x, *v0y, *v0z, *dens, *pkxx, *pkyy, *pkzz, *pcxx, *pcyy, *pczz; + double *dens, *pkxx, *pkyy, *pkzz, *pcxx, *pcyy, *pczz; double *tdens, *tpkxx, *tpkyy, *tpkzz, *tpcxx, *tpcyy, *tpczz; class NeighList *list; void compute_pressure(double, double, double, double, double, double, double, double); From fc468accf57992edd8e688feb88dcabcba3f28c7 Mon Sep 17 00:00:00 2001 From: Olav Galteland Date: Thu, 2 Jun 2022 18:34:48 +0200 Subject: [PATCH 296/585] clang-format and removed more unused variables --- src/EXTRA-COMPUTE/compute_stress_cartesian.cpp | 15 +++------------ 1 file changed, 3 insertions(+), 12 deletions(-) diff --git a/src/EXTRA-COMPUTE/compute_stress_cartesian.cpp b/src/EXTRA-COMPUTE/compute_stress_cartesian.cpp index a52779ebdd..62dfbfd12a 100644 --- a/src/EXTRA-COMPUTE/compute_stress_cartesian.cpp +++ b/src/EXTRA-COMPUTE/compute_stress_cartesian.cpp @@ -136,9 +136,6 @@ ComputeStressCartesian::ComputeStressCartesian(LAMMPS *lmp, int narg, char **arg size_array_cols = 7 + dims; // dir1, dir2, number density, pkxx, pkyy, pkzz, pcxx, pcyy, pczz size_array_rows = nbins1 * nbins2; - memory->create(v0x, nbins1 * nbins2, "v0x"); - memory->create(v0y, nbins1 * nbins2, "v0y"); - memory->create(v0z, nbins1 * nbins2, "v0z"); memory->create(dens, nbins1 * nbins2, "dens"); memory->create(pkxx, nbins1 * nbins2, "pkxx"); memory->create(pkyy, nbins1 * nbins2, "pkyy"); @@ -161,9 +158,6 @@ ComputeStressCartesian::ComputeStressCartesian(LAMMPS *lmp, int narg, char **arg ComputeStressCartesian::~ComputeStressCartesian() { memory->destroy(dens); - memory->destroy(v0x); - memory->destroy(v0y); - memory->destroy(v0z); memory->destroy(pkxx); memory->destroy(pkyy); memory->destroy(pkzz); @@ -240,9 +234,6 @@ void ComputeStressCartesian::compute_array() // Zero arrays for (bin = 0; bin < nbins1 * nbins2; bin++) { tdens[bin] = 0; - v0x[bin] = 0; - v0y[bin] = 0; - v0z[bin] = 0; tpkxx[bin] = 0; tpkyy[bin] = 0; tpkzz[bin] = 0; @@ -259,9 +250,9 @@ void ComputeStressCartesian::compute_array() j = bin1 + bin2 * nbins1; tdens[j] += 1; - tpkxx[j] += mass[type[i]] * (v[i][0]-v0x[j]) * (v[i][0]-v0x[j]); - tpkyy[j] += mass[type[i]] * (v[i][1]-v0y[j]) * (v[i][1]-v0y[j]); - tpkzz[j] += mass[type[i]] * (v[i][2]-v0z[j]) * (v[i][2]-v0z[j]); + tpkxx[j] += mass[type[i]] * v[i][0] * v[i][0]; + tpkyy[j] += mass[type[i]] * v[i][1] * v[i][1]; + tpkzz[j] += mass[type[i]] * v[i][2] * v[i][2]; } // loop over neighbors of my atoms From a74f64a737af4102c39213846f0f4f258e117c87 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 2 Jun 2022 12:55:23 -0400 Subject: [PATCH 297/585] do not allow per-atom arrays to shrink --- src/atom_vec.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/atom_vec.cpp b/src/atom_vec.cpp index deff0cfd58..dbacf2237a 100644 --- a/src/atom_vec.cpp +++ b/src/atom_vec.cpp @@ -207,7 +207,7 @@ void AtomVec::grow(int n) if (n == 0) grow_nmax(); else - nmax = n; + nmax = MAX(n,nmax); atom->nmax = nmax; if (nmax < 0 || nmax > MAXSMALLINT) error->one(FLERR, "Per-processor system is too big"); From 9d252fe0d24dce0fd40c2b758e13905670cd2002 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 2 Jun 2022 12:57:45 -0400 Subject: [PATCH 298/585] remove error docs and apply clang-format --- .../compute_stress_cartesian.cpp | 19 +++++++++---------- src/EXTRA-COMPUTE/compute_stress_cartesian.h | 19 ------------------- 2 files changed, 9 insertions(+), 29 deletions(-) diff --git a/src/EXTRA-COMPUTE/compute_stress_cartesian.cpp b/src/EXTRA-COMPUTE/compute_stress_cartesian.cpp index 62dfbfd12a..25c3117b0f 100644 --- a/src/EXTRA-COMPUTE/compute_stress_cartesian.cpp +++ b/src/EXTRA-COMPUTE/compute_stress_cartesian.cpp @@ -80,22 +80,22 @@ ComputeStressCartesian::ComputeStressCartesian(LAMMPS *lmp, int narg, char **arg dir2 = 0; bin_width1 = utils::numeric(FLERR, arg[4], false, lmp); - bin_width2 = domain->boxhi[dir2]-domain->boxlo[dir2]; + bin_width2 = domain->boxhi[dir2] - domain->boxlo[dir2]; nbins1 = (int) ((domain->boxhi[dir1] - domain->boxlo[dir1]) / bin_width1); nbins2 = 1; - + // adjust bin width if not a perfect match double tmp_binwidth = (domain->boxhi[dir1] - domain->boxlo[dir1]) / nbins1; if ((fabs(tmp_binwidth - bin_width1) > SMALL) && (comm->me == 0)) - utils::logmesg(lmp, "Adjusting second bin width for compute {} from {:.6f} to {:.6f}\n", - style, bin_width1, tmp_binwidth); + utils::logmesg(lmp, "Adjusting second bin width for compute {} from {:.6f} to {:.6f}\n", style, + bin_width1, tmp_binwidth); bin_width1 = tmp_binwidth; if (bin_width1 <= 0.0) error->all(FLERR, "Illegal compute stress/cartesian command. Bin width must be > 0"); else if (bin_width1 > domain->boxhi[dir1] - domain->boxlo[dir1]) error->all(FLERR, "Illegal compute stress/cartesian command. Bin width larger than box."); - + invV = bin_width1; if (dims == 2) { if (strcmp(arg[5], "x") == 0) @@ -109,7 +109,7 @@ ComputeStressCartesian::ComputeStressCartesian(LAMMPS *lmp, int narg, char **arg bin_width2 = utils::numeric(FLERR, arg[6], false, lmp); nbins2 = (int) ((domain->boxhi[dir2] - domain->boxlo[dir2]) / bin_width2); - + // adjust bin width if not a perfect match tmp_binwidth = (domain->boxhi[dir2] - domain->boxlo[dir2]) / nbins2; if ((fabs(tmp_binwidth - bin_width2) > SMALL) && (comm->me == 0)) @@ -241,7 +241,7 @@ void ComputeStressCartesian::compute_array() tpcyy[bin] = 0; tpczz[bin] = 0; } - + // calculate number density and kinetic contribution to pressure for (i = 0; i < nlocal; i++) { bin1 = (int) (x[i][dir1] / bin_width1) % nbins1; @@ -356,9 +356,8 @@ void ComputeStressCartesian::compute_array() } } - void ComputeStressCartesian::compute_pressure(double fpair, double xi, double yi, double xj, - double yj, double delx, double dely, double delz) + double yj, double delx, double dely, double delz) { int bin1, bin2, next_bin1, next_bin2; double la = 0.0, lb = 0.0, l_sum = 0.0; @@ -369,7 +368,7 @@ void ComputeStressCartesian::compute_pressure(double fpair, double xi, double yi next_bin1 = (int) floor(xi / bin_width1); next_bin2 = (int) floor(yi / bin_width2); - + // Integrating along line while (lb < 1.0) { bin1 = next_bin1; diff --git a/src/EXTRA-COMPUTE/compute_stress_cartesian.h b/src/EXTRA-COMPUTE/compute_stress_cartesian.h index 1aa7f34f6e..63e33a5407 100644 --- a/src/EXTRA-COMPUTE/compute_stress_cartesian.h +++ b/src/EXTRA-COMPUTE/compute_stress_cartesian.h @@ -48,22 +48,3 @@ class ComputeStressCartesian : public Compute { #endif #endif - -/* ERROR/WARNING messages: - -E: Illegal ... command - -Self-explanatory. Check the input script syntax and compare to the -documentation for the command. You can use -echo screen as a -command-line option when running LAMMPS to see the offending line. - -E: No pair style is defined for compute stress/cartesian - -Self-explanatory. - -E: Pair style does not support compute stress/cartesian - -The pair style does not have a single() function, so it can -not be invoked by compute stress/cartesian. - -*/ From 260a5f4d52828774c5d54b70abc09d4cf06842b7 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 2 Jun 2022 14:39:08 -0400 Subject: [PATCH 299/585] update false positives --- doc/utils/sphinx-config/false_positives.txt | 2 ++ 1 file changed, 2 insertions(+) diff --git a/doc/utils/sphinx-config/false_positives.txt b/doc/utils/sphinx-config/false_positives.txt index 319d1b0a41..32b132be16 100644 --- a/doc/utils/sphinx-config/false_positives.txt +++ b/doc/utils/sphinx-config/false_positives.txt @@ -1564,6 +1564,7 @@ jpeglib jpg JPG jpl +json Jth jtranch jtype @@ -3213,6 +3214,7 @@ statvolt stdin stdio stdlib +stdout steelblue Stegailov Steinbach From 2a054c17beacbbe0a16644699b2dcb99165bb98a Mon Sep 17 00:00:00 2001 From: Yury Lysogorskiy Date: Thu, 2 Jun 2022 23:01:54 +0200 Subject: [PATCH 300/585] - set species type for NULL atom type to -1. species_type=-1 value will not reach ACE Evaluator::compute_atom, but if it will ,then error will be thrown there - updating lib pace MD5SUM (for both make and cmake installation scenario), but use same tag name v.2021.10.25.fix2 (add override keyword to ACERadialFunctions, add check for species_type==-1, fix yaml_cpp CMakeLists.txt) --- cmake/Modules/Packages/ML-PACE.cmake | 2 +- lib/pace/Install.py | 2 +- src/ML-PACE/pair_pace.cpp | 6 ++++-- 3 files changed, 6 insertions(+), 4 deletions(-) diff --git a/cmake/Modules/Packages/ML-PACE.cmake b/cmake/Modules/Packages/ML-PACE.cmake index 8f8d93f3ae..adfdd8ebf8 100644 --- a/cmake/Modules/Packages/ML-PACE.cmake +++ b/cmake/Modules/Packages/ML-PACE.cmake @@ -1,6 +1,6 @@ set(PACELIB_URL "https://github.com/ICAMS/lammps-user-pace/archive/refs/tags/v.2021.10.25.fix2.tar.gz" CACHE STRING "URL for PACE evaluator library sources") -set(PACELIB_MD5 "d1984c9d5bf88715fc20b23dcf95aa12" CACHE STRING "MD5 checksum of PACE evaluator library tarball") +set(PACELIB_MD5 "32394d799bc282bb57696c78c456e64f" CACHE STRING "MD5 checksum of PACE evaluator library tarball") mark_as_advanced(PACELIB_URL) mark_as_advanced(PACELIB_MD5) diff --git a/lib/pace/Install.py b/lib/pace/Install.py index 165b90774e..790acd4cf4 100644 --- a/lib/pace/Install.py +++ b/lib/pace/Install.py @@ -24,7 +24,7 @@ checksums = { \ 'v.2021.9.28' : 'f98363bb98adc7295ea63974738c2a1b', 'v.2021.10.25' : 'a2ac3315c41a1a4a5c912bcb1bc9c5cc', 'v.2021.10.25.fix': 'e0572de57039d4afedefb25707b6ceae', - 'v.2021.10.25.fix2': 'd1984c9d5bf88715fc20b23dcf95aa12' + 'v.2021.10.25.fix2': '32394d799bc282bb57696c78c456e64f' } diff --git a/src/ML-PACE/pair_pace.cpp b/src/ML-PACE/pair_pace.cpp index 56463a921e..87e580b8d3 100644 --- a/src/ML-PACE/pair_pace.cpp +++ b/src/ML-PACE/pair_pace.cpp @@ -180,7 +180,7 @@ void PairPACE::compute(int eflag, int vflag) try { aceimpl->ace->compute_atom(i, x, type, jnum, jlist); - } catch (exception &e) { + } catch (std::exception &e) { error->one(FLERR, e.what()); } @@ -317,7 +317,9 @@ void PairPACE::coeff(int narg, char **arg) for (int i = 1; i <= n; i++) { char *elemname = arg[2 + i]; if (strcmp(elemname, "NULL") == 0) { - aceimpl->ace->element_type_mapping(i) = 0; + // species_type=-1 value will not reach ACE Evaluator::compute_atom, + // but if it will ,then error will be thrown there + aceimpl->ace->element_type_mapping(i) = -1; map[i] = -1; if (comm->me == 0) utils::logmesg(lmp, "Skipping LAMMPS atom type #{}(NULL)\n", i); } else { From aad4d093b822f1baa6cfe3ceea531c684a3a9edf Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 2 Jun 2022 18:18:32 -0400 Subject: [PATCH 301/585] correctly handle the situation that the build folder may have multiple libs downloaded --- cmake/Modules/LAMMPSUtils.cmake | 18 ++++++++++++++++++ cmake/Modules/Packages/ML-PACE.cmake | 2 +- 2 files changed, 19 insertions(+), 1 deletion(-) diff --git a/cmake/Modules/LAMMPSUtils.cmake b/cmake/Modules/LAMMPSUtils.cmake index 943c3d851e..9f624fc007 100644 --- a/cmake/Modules/LAMMPSUtils.cmake +++ b/cmake/Modules/LAMMPSUtils.cmake @@ -24,6 +24,24 @@ function(validate_option name values) endif() endfunction(validate_option) +# helper function for getting the most recently modified file or folder from a glob pattern +function(get_newest_file path variable) + file(GLOB _dirs ${path}) + set(_besttime 2000-01-01T00:00:00) + set(_bestfile "") + foreach(_dir ${_dirs}) + file(TIMESTAMP ${_dir} _newtime) + if(_newtime IS_NEWER_THAN _besttime) + set(_bestfile ${_dir}) + set(_besttime ${_newtime}) + endif() + endforeach() + if(_bestfile STREQUAL "") + message(FATAL_ERROR "Could not find valid path at: ${path}") + endif() + set(${variable} ${_bestfile} PARENT_SCOPE) +endfunction() + function(get_lammps_version version_header variable) file(STRINGS ${version_header} line REGEX LAMMPS_VERSION) set(MONTHS x Jan Feb Mar Apr May Jun Jul Aug Sep Oct Nov Dec) diff --git a/cmake/Modules/Packages/ML-PACE.cmake b/cmake/Modules/Packages/ML-PACE.cmake index adfdd8ebf8..c647c8873a 100644 --- a/cmake/Modules/Packages/ML-PACE.cmake +++ b/cmake/Modules/Packages/ML-PACE.cmake @@ -13,8 +13,8 @@ execute_process( COMMAND ${CMAKE_COMMAND} -E tar xzf libpace.tar.gz WORKING_DIRECTORY ${CMAKE_BINARY_DIR} ) +get_newest_file(${CMAKE_BINARY_DIR}/lammps-user-pace-* lib-pace) -file(GLOB lib-pace ${CMAKE_BINARY_DIR}/lammps-user-pace-*) # enforce building libyaml-cpp as static library and turn off optional features set(YAML_BUILD_SHARED_LIBS OFF) set(YAML_CPP_BUILD_CONTRIB OFF) From f68247ad6aed9cfd41b818095e05dfa1dae6f586 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 3 Jun 2022 05:10:00 -0400 Subject: [PATCH 302/585] add ML-PACE and PLUGIN packages to be compiled with MinGW cross-compilers --- cmake/presets/mingw-cross.cmake | 4 +++- 1 file changed, 3 insertions(+), 1 deletion(-) diff --git a/cmake/presets/mingw-cross.cmake b/cmake/presets/mingw-cross.cmake index 81db71729a..29de394b8e 100644 --- a/cmake/presets/mingw-cross.cmake +++ b/cmake/presets/mingw-cross.cmake @@ -46,8 +46,9 @@ set(WIN_PACKAGES MISC ML-HDNNP ML-IAP - ML-SNAP + ML-PACE ML-RANN + ML-SNAP MOFFF MOLECULE MOLFILE @@ -56,6 +57,7 @@ set(WIN_PACKAGES ORIENT PERI PHONON + PLUGIN POEMS PTM QEQ From f9b5679c0078e2fe3b312dd273d5370249dd7fe7 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 3 Jun 2022 07:16:19 -0400 Subject: [PATCH 303/585] remove unused function arguments --- src/EXTRA-COMPUTE/compute_stress_cartesian.cpp | 6 +++--- src/EXTRA-COMPUTE/compute_stress_cartesian.h | 2 +- 2 files changed, 4 insertions(+), 4 deletions(-) diff --git a/src/EXTRA-COMPUTE/compute_stress_cartesian.cpp b/src/EXTRA-COMPUTE/compute_stress_cartesian.cpp index 25c3117b0f..f873c70bae 100644 --- a/src/EXTRA-COMPUTE/compute_stress_cartesian.cpp +++ b/src/EXTRA-COMPUTE/compute_stress_cartesian.cpp @@ -318,7 +318,7 @@ void ComputeStressCartesian::compute_array() // Check if inside cut-off if (rsq >= cutsq[itype][jtype]) continue; pair->single(i, j, itype, jtype, rsq, factor_coul, factor_lj, fpair); - compute_pressure(fpair, xi1, xi2, xj1, xj2, delx, dely, delz); + compute_pressure(fpair, xi1, xi2, delx, dely, delz); } } @@ -356,8 +356,8 @@ void ComputeStressCartesian::compute_array() } } -void ComputeStressCartesian::compute_pressure(double fpair, double xi, double yi, double xj, - double yj, double delx, double dely, double delz) +void ComputeStressCartesian::compute_pressure(double fpair, double xi, double yi, double delx, + double dely, double delz) { int bin1, bin2, next_bin1, next_bin2; double la = 0.0, lb = 0.0, l_sum = 0.0; diff --git a/src/EXTRA-COMPUTE/compute_stress_cartesian.h b/src/EXTRA-COMPUTE/compute_stress_cartesian.h index 63e33a5407..d4505a1e8e 100644 --- a/src/EXTRA-COMPUTE/compute_stress_cartesian.h +++ b/src/EXTRA-COMPUTE/compute_stress_cartesian.h @@ -41,7 +41,7 @@ class ComputeStressCartesian : public Compute { double *dens, *pkxx, *pkyy, *pkzz, *pcxx, *pcyy, *pczz; double *tdens, *tpkxx, *tpkyy, *tpkzz, *tpcxx, *tpcyy, *tpczz; class NeighList *list; - void compute_pressure(double, double, double, double, double, double, double, double); + void compute_pressure(double, double, double, double, double, double); }; } // namespace LAMMPS_NS From 7c4d77f7765eec4d989900357c729646891a0f38 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 3 Jun 2022 07:36:25 -0400 Subject: [PATCH 304/585] tweak epsilon for portability --- unittest/force-styles/tests/manybody-pair-pace_product.yaml | 2 +- unittest/force-styles/tests/manybody-pair-pace_recursive.yaml | 2 +- 2 files changed, 2 insertions(+), 2 deletions(-) diff --git a/unittest/force-styles/tests/manybody-pair-pace_product.yaml b/unittest/force-styles/tests/manybody-pair-pace_product.yaml index 9aac9ddcae..1e82029777 100644 --- a/unittest/force-styles/tests/manybody-pair-pace_product.yaml +++ b/unittest/force-styles/tests/manybody-pair-pace_product.yaml @@ -1,7 +1,7 @@ --- lammps_version: 17 Feb 2022 date_generated: Fri Mar 18 22:17:48 2022 -epsilon: 5e-13 +epsilon: 1e-12 skip_tests: prerequisites: ! | pair pace diff --git a/unittest/force-styles/tests/manybody-pair-pace_recursive.yaml b/unittest/force-styles/tests/manybody-pair-pace_recursive.yaml index eef7509606..f20440c85d 100644 --- a/unittest/force-styles/tests/manybody-pair-pace_recursive.yaml +++ b/unittest/force-styles/tests/manybody-pair-pace_recursive.yaml @@ -1,7 +1,7 @@ --- lammps_version: 10 Mar 2021 date_generated: Wed Apr 7 19:30:07 2021 -epsilon: 5e-13 +epsilon: 1e-12 prerequisites: ! | pair pace pre_commands: ! | From 587438eb30ecc99f3c9877cecdd1bde3cbfceb9a Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 3 Jun 2022 09:14:34 -0400 Subject: [PATCH 305/585] fix typo in read_data add merge example --- doc/src/read_data.rst | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/doc/src/read_data.rst b/doc/src/read_data.rst index 68e1efc496..b10e758444 100644 --- a/doc/src/read_data.rst +++ b/doc/src/read_data.rst @@ -56,7 +56,7 @@ Examples read_data ../run7/data.polymer.gz read_data data.protein fix mycmap crossterm CMAP read_data data.water add append offset 3 1 1 1 1 shift 0.0 0.0 50.0 - read_data data.water add merge 1 group solvent + read_data data.water add merge group solvent Description """"""""""" From 25c74652e36e594dfd827bc41360f7a30f69fe16 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sat, 4 Jun 2022 04:25:13 -0400 Subject: [PATCH 306/585] remove bogus tags --- unittest/force-styles/tests/atomic-pair-sw_angle_table.yaml | 1 - unittest/force-styles/tests/atomic-pair-threebody_table.yaml | 1 - 2 files changed, 2 deletions(-) diff --git a/unittest/force-styles/tests/atomic-pair-sw_angle_table.yaml b/unittest/force-styles/tests/atomic-pair-sw_angle_table.yaml index b8eae7848b..7229a3cd26 100644 --- a/unittest/force-styles/tests/atomic-pair-sw_angle_table.yaml +++ b/unittest/force-styles/tests/atomic-pair-sw_angle_table.yaml @@ -1,6 +1,5 @@ --- lammps_version: 4 May 2022 -tags: generated date_generated: Wed Jun 1 15:17:22 2022 epsilon: 1e-12 skip_tests: single diff --git a/unittest/force-styles/tests/atomic-pair-threebody_table.yaml b/unittest/force-styles/tests/atomic-pair-threebody_table.yaml index 605f18a9a6..bb3c8c1c1b 100644 --- a/unittest/force-styles/tests/atomic-pair-threebody_table.yaml +++ b/unittest/force-styles/tests/atomic-pair-threebody_table.yaml @@ -1,6 +1,5 @@ --- lammps_version: 4 May 2022 -tags: generated date_generated: Wed Jun 1 15:28:13 2022 epsilon: 1e-05 skip_tests: single From fa9ad10bc1c32beed713e3b618c1b91e544fdd38 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sat, 4 Jun 2022 05:00:12 -0400 Subject: [PATCH 307/585] add missing line to read_data docs about atom style dielectric --- doc/src/read_data.rst | 2 ++ 1 file changed, 2 insertions(+) diff --git a/doc/src/read_data.rst b/doc/src/read_data.rst index b10e758444..853d86785e 100644 --- a/doc/src/read_data.rst +++ b/doc/src/read_data.rst @@ -622,6 +622,8 @@ of analysis. - atom-ID molecule-ID atom-type x y z * - charge - atom-ID atom-type q x y z + * - dielectric + - atom-ID atom-type q x y z normx normy normz area ed em epsilon curvature * - dipole - atom-ID atom-type q x y z mux muy muz * - dpd From 0dc486c90b03d7d372f0b4813085d2847a220b77 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sat, 4 Jun 2022 05:00:28 -0400 Subject: [PATCH 308/585] fix bug introduced during stringification --- src/DIELECTRIC/atom_vec_dielectric.cpp | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/src/DIELECTRIC/atom_vec_dielectric.cpp b/src/DIELECTRIC/atom_vec_dielectric.cpp index b15b233991..67bb9f7dc3 100644 --- a/src/DIELECTRIC/atom_vec_dielectric.cpp +++ b/src/DIELECTRIC/atom_vec_dielectric.cpp @@ -78,9 +78,9 @@ AtomVecDielectric::AtomVecDielectric(LAMMPS *_lmp) : AtomVec(_lmp) "mu", "area", "ed", "em", "epsilon", "curvature", "q_unscaled"}; fields_create = {"q", "molecule", "num_bond", "num_angle", "num_dihedral", "num_improper", "nspecial", "mu", "area", "ed", "em", "epsilon", "curvature", "q_unscaled"}; - fields_data_atom = { "id", "molecule", "type", "q", "x", "mu3", "area", "ed", "em", "epsilon", + fields_data_atom = {"id", "molecule", "type", "q", "x", "mu3", "area", "ed", "em", "epsilon", "curvature"}; - fields_data_vel = {"id v"}; + fields_data_vel = {"id", "v"}; // clang-format on setup_fields(); From 3beb071d382bd3d76ad48ebfd37f2fb13c0a92f5 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sat, 4 Jun 2022 05:15:14 -0400 Subject: [PATCH 309/585] make plugin compilation settings with MSVC consistent and more compile specific --- cmake/CMakeLists.txt | 12 +++++++----- examples/kim/plugin/CMakeLists.txt | 11 ++++++++--- examples/plugins/CMakeLists.txt | 11 ++++++++--- 3 files changed, 23 insertions(+), 11 deletions(-) diff --git a/cmake/CMakeLists.txt b/cmake/CMakeLists.txt index 2566497c0e..6af33cd5b3 100644 --- a/cmake/CMakeLists.txt +++ b/cmake/CMakeLists.txt @@ -135,11 +135,13 @@ set(CMAKE_CXX_EXTENSIONS OFF CACHE BOOL "Use compiler extensions") # ugly hacks for MSVC which by default always reports an old C++ standard in the __cplusplus macro # and prints lots of pointless warnings about "unsafe" functions if(MSVC) - add_compile_options(/Zc:__cplusplus) - add_compile_options(/wd4244) - add_compile_options(/wd4267) - if(LAMMPS_EXCEPTIONS) - add_compile_options(/EHsc) + if(CMAKE_CXX_COMPILER_ID STREQUAL "MSVC") + add_compile_options(/Zc:__cplusplus) + add_compile_options(/wd4244) + add_compile_options(/wd4267) + if(LAMMPS_EXCEPTIONS) + add_compile_options(/EHsc) + endif() endif() add_compile_definitions(_CRT_SECURE_NO_WARNINGS) endif() diff --git a/examples/kim/plugin/CMakeLists.txt b/examples/kim/plugin/CMakeLists.txt index f4cb5f598d..851f4db607 100644 --- a/examples/kim/plugin/CMakeLists.txt +++ b/examples/kim/plugin/CMakeLists.txt @@ -28,9 +28,14 @@ endif() # ugly hacks for MSVC which by default always reports an old C++ standard in the __cplusplus macro # and prints lots of pointless warnings about "unsafe" functions if(MSVC) - add_compile_options(/Zc:__cplusplus) - add_compile_options(/wd4244) - add_compile_options(/wd4267) + if(CMAKE_CXX_COMPILER_ID STREQUAL "MSVC") + add_compile_options(/Zc:__cplusplus) + add_compile_options(/wd4244) + add_compile_options(/wd4267) + if(LAMMPS_EXCEPTIONS) + add_compile_options(/EHsc) + endif() + endif() add_compile_definitions(_CRT_SECURE_NO_WARNINGS) endif() diff --git a/examples/plugins/CMakeLists.txt b/examples/plugins/CMakeLists.txt index 8bef055ad3..688835de56 100644 --- a/examples/plugins/CMakeLists.txt +++ b/examples/plugins/CMakeLists.txt @@ -32,9 +32,14 @@ else() # ugly hacks for MSVC which by default always reports an old C++ standard in the __cplusplus macro # and prints lots of pointless warnings about "unsafe" functions if(MSVC) - add_compile_options(/Zc:__cplusplus) - add_compile_options(/wd4244) - add_compile_options(/wd4267) + if(CMAKE_CXX_COMPILER_ID STREQUAL "MSVC") + add_compile_options(/Zc:__cplusplus) + add_compile_options(/wd4244) + add_compile_options(/wd4267) + if(LAMMPS_EXCEPTIONS) + add_compile_options(/EHsc) + endif() + endif() add_compile_definitions(_CRT_SECURE_NO_WARNINGS) endif() endif() From a232bd330223d5408836010ea6b5e7d50c0df2ac Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sat, 4 Jun 2022 10:59:25 -0400 Subject: [PATCH 310/585] refactor LAMMPS plugin building to share more code and to add a demo for ML-PACE --- cmake/Modules/LAMMPSInterfacePlugin.cmake | 197 ++++++++++++++++++ cmake/Modules/Packages/ML-PACE.cmake | 5 +- examples/PACKAGES/pace/plugin/CMakeLists.txt | 36 ++++ .../pace/plugin/LAMMPSInterfacePlugin.cmake | 1 + examples/PACKAGES/pace/plugin/ML-PACE.cmake | 1 + .../pace/plugin/lammps-text-logo-wide.bmp | Bin 0 -> 25818 bytes examples/PACKAGES/pace/plugin/lammps.ico | Bin 0 -> 209266 bytes examples/PACKAGES/pace/plugin/paceplugin.cpp | 28 +++ examples/PACKAGES/pace/plugin/paceplugin.nsis | 157 ++++++++++++++ examples/kim/plugin/CMakeLists.txt | 46 +--- examples/kim/plugin/LAMMPSInterfaceCXX.cmake | 88 -------- .../kim/plugin/LAMMPSInterfacePlugin.cmake | 1 + 12 files changed, 427 insertions(+), 133 deletions(-) create mode 100644 cmake/Modules/LAMMPSInterfacePlugin.cmake create mode 100644 examples/PACKAGES/pace/plugin/CMakeLists.txt create mode 120000 examples/PACKAGES/pace/plugin/LAMMPSInterfacePlugin.cmake create mode 120000 examples/PACKAGES/pace/plugin/ML-PACE.cmake create mode 100644 examples/PACKAGES/pace/plugin/lammps-text-logo-wide.bmp create mode 100644 examples/PACKAGES/pace/plugin/lammps.ico create mode 100644 examples/PACKAGES/pace/plugin/paceplugin.cpp create mode 100644 examples/PACKAGES/pace/plugin/paceplugin.nsis delete mode 100644 examples/kim/plugin/LAMMPSInterfaceCXX.cmake create mode 120000 examples/kim/plugin/LAMMPSInterfacePlugin.cmake diff --git a/cmake/Modules/LAMMPSInterfacePlugin.cmake b/cmake/Modules/LAMMPSInterfacePlugin.cmake new file mode 100644 index 0000000000..ec7a739785 --- /dev/null +++ b/cmake/Modules/LAMMPSInterfacePlugin.cmake @@ -0,0 +1,197 @@ +# CMake script code to define LAMMPS settings required for building LAMMPS plugins + +# enforce out-of-source build +if(${CMAKE_SOURCE_DIR} STREQUAL ${CMAKE_BINARY_DIR}) + message(FATAL_ERROR "In-source builds are not allowed. You must create and use a build directory. " + "Please remove CMakeCache.txt and CMakeFiles first.") +endif() + +# global LAMMPS/plugin build settings +set(LAMMPS_SOURCE_DIR "" CACHE PATH "Location of LAMMPS sources folder") +if(NOT LAMMPS_SOURCE_DIR) + message(FATAL_ERROR "Must set LAMMPS_SOURCE_DIR") +endif() + +# by default, install into $HOME/.local (not /usr/local), +# so that no root access (and sudo) is needed +if(CMAKE_INSTALL_PREFIX_INITIALIZED_TO_DEFAULT) + set(CMAKE_INSTALL_PREFIX "$ENV{HOME}/.local" CACHE PATH "Default install path" FORCE) +endif() + +# ugly hacks for MSVC which by default always reports an old C++ standard in the __cplusplus macro +# and prints lots of pointless warnings about "unsafe" functions +if(MSVC) + if(CMAKE_CXX_COMPILER_ID STREQUAL "MSVC") + add_compile_options(/Zc:__cplusplus) + add_compile_options(/wd4244) + add_compile_options(/wd4267) + if(LAMMPS_EXCEPTIONS) + add_compile_options(/EHsc) + endif() + endif() + add_compile_definitions(_CRT_SECURE_NO_WARNINGS) +endif() + +# C++11 is required +set(CMAKE_CXX_STANDARD 11) +set(CMAKE_CXX_STANDARD_REQUIRED ON) + +# Need -restrict with Intel compilers +if(CMAKE_CXX_COMPILER_ID STREQUAL "Intel") + set(CMAKE_CXX_FLAGS "${CMAKE_CXX_FLAGS} -restrict") +endif() +set(CMAKE_POSITION_INDEPENDENT_CODE TRUE) + +####### +# helper functions from LAMMPSUtils.cmake +function(validate_option name values) + string(TOLOWER ${${name}} needle_lower) + string(TOUPPER ${${name}} needle_upper) + list(FIND ${values} ${needle_lower} IDX_LOWER) + list(FIND ${values} ${needle_upper} IDX_UPPER) + if(${IDX_LOWER} LESS 0 AND ${IDX_UPPER} LESS 0) + list_to_bulletpoints(POSSIBLE_VALUE_LIST ${${values}}) + message(FATAL_ERROR "\n########################################################################\n" + "Invalid value '${${name}}' for option ${name}\n" + "\n" + "Possible values are:\n" + "${POSSIBLE_VALUE_LIST}" + "########################################################################") + endif() +endfunction(validate_option) + +# helper function for getting the most recently modified file or folder from a glob pattern +function(get_newest_file path variable) + file(GLOB _dirs ${path}) + set(_besttime 2000-01-01T00:00:00) + set(_bestfile "") + foreach(_dir ${_dirs}) + file(TIMESTAMP ${_dir} _newtime) + if(_newtime IS_NEWER_THAN _besttime) + set(_bestfile ${_dir}) + set(_besttime ${_newtime}) + endif() + endforeach() + if(_bestfile STREQUAL "") + message(FATAL_ERROR "Could not find valid path at: ${path}") + endif() + set(${variable} ${_bestfile} PARENT_SCOPE) +endfunction() + +################################################################################# +# LAMMPS C++ interface. We only need the header related parts except on windows. +add_library(lammps INTERFACE) +target_include_directories(lammps INTERFACE ${LAMMPS_SOURCE_DIR}) +if((CMAKE_SYSTEM_NAME STREQUAL "Windows") AND CMAKE_CROSSCOMPILING) + target_link_libraries(lammps INTERFACE ${CMAKE_BINARY_DIR}/../liblammps.dll.a) +endif() + +################################################################################ +# MPI configuration +if(NOT CMAKE_CROSSCOMPILING) + find_package(MPI QUIET) + option(BUILD_MPI "Build MPI version" ${MPI_FOUND}) +else() + option(BUILD_MPI "Build MPI version" OFF) +endif() + +if(BUILD_MPI) + # do not include the (obsolete) MPI C++ bindings which makes + # for leaner object files and avoids namespace conflicts + set(MPI_CXX_SKIP_MPICXX TRUE) + # We use a non-standard procedure to cross-compile with MPI on Windows + if((CMAKE_SYSTEM_NAME STREQUAL "Windows") AND CMAKE_CROSSCOMPILING) + # Download and configure custom MPICH files for Windows + message(STATUS "Downloading and configuring MPICH-1.4.1 for Windows") + set(MPICH2_WIN64_DEVEL_URL "${LAMMPS_THIRDPARTY_URL}/mpich2-win64-devel.tar.gz" CACHE STRING "URL for MPICH2 (win64) tarball") + set(MPICH2_WIN32_DEVEL_URL "${LAMMPS_THIRDPARTY_URL}/mpich2-win32-devel.tar.gz" CACHE STRING "URL for MPICH2 (win32) tarball") + set(MPICH2_WIN64_DEVEL_MD5 "4939fdb59d13182fd5dd65211e469f14" CACHE STRING "MD5 checksum of MPICH2 (win64) tarball") + set(MPICH2_WIN32_DEVEL_MD5 "a61d153500dce44e21b755ee7257e031" CACHE STRING "MD5 checksum of MPICH2 (win32) tarball") + mark_as_advanced(MPICH2_WIN64_DEVEL_URL) + mark_as_advanced(MPICH2_WIN32_DEVEL_URL) + mark_as_advanced(MPICH2_WIN64_DEVEL_MD5) + mark_as_advanced(MPICH2_WIN32_DEVEL_MD5) + + include(ExternalProject) + if(CMAKE_SYSTEM_PROCESSOR STREQUAL "x86_64") + ExternalProject_Add(mpi4win_build + URL ${MPICH2_WIN64_DEVEL_URL} + URL_MD5 ${MPICH2_WIN64_DEVEL_MD5} + CONFIGURE_COMMAND "" BUILD_COMMAND "" INSTALL_COMMAND "" + BUILD_BYPRODUCTS /lib/libmpi.a) + else() + ExternalProject_Add(mpi4win_build + URL ${MPICH2_WIN32_DEVEL_URL} + URL_MD5 ${MPICH2_WIN32_DEVEL_MD5} + CONFIGURE_COMMAND "" BUILD_COMMAND "" INSTALL_COMMAND "" + BUILD_BYPRODUCTS /lib/libmpi.a) + endif() + + ExternalProject_get_property(mpi4win_build SOURCE_DIR) + file(MAKE_DIRECTORY "${SOURCE_DIR}/include") + add_library(MPI::MPI_CXX UNKNOWN IMPORTED) + set_target_properties(MPI::MPI_CXX PROPERTIES + IMPORTED_LOCATION "${SOURCE_DIR}/lib/libmpi.a" + INTERFACE_INCLUDE_DIRECTORIES "${SOURCE_DIR}/include" + INTERFACE_COMPILE_DEFINITIONS "MPICH_SKIP_MPICXX") + add_dependencies(MPI::MPI_CXX mpi4win_build) + + # set variables for status reporting at the end of CMake run + set(MPI_CXX_INCLUDE_PATH "${SOURCE_DIR}/include") + set(MPI_CXX_COMPILE_DEFINITIONS "MPICH_SKIP_MPICXX") + set(MPI_CXX_LIBRARIES "${SOURCE_DIR}/lib/libmpi.a") + else() + find_package(MPI REQUIRED) + option(LAMMPS_LONGLONG_TO_LONG "Workaround if your system or MPI version does not recognize 'long long' data types" OFF) + if(LAMMPS_LONGLONG_TO_LONG) + target_compile_definitions(lammps INTERFACE -DLAMMPS_LONGLONG_TO_LONG) + endif() + endif() + target_link_libraries(lammps INTERFACE MPI::MPI_CXX) +else() + add_library(mpi_stubs INTERFACE) + target_include_directories(mpi_stubs INTERFACE $) + target_link_libraries(lammps INTERFACE mpi_stubs) +endif() + +################################################################################ +# detect if we may enable OpenMP support by default +set(BUILD_OMP_DEFAULT OFF) +find_package(OpenMP QUIET) +if(OpenMP_FOUND) + check_include_file_cxx(omp.h HAVE_OMP_H_INCLUDE) + if(HAVE_OMP_H_INCLUDE) + set(BUILD_OMP_DEFAULT ON) + endif() +endif() + +option(BUILD_OMP "Build with OpenMP support" ${BUILD_OMP_DEFAULT}) + +if(BUILD_OMP) + find_package(OpenMP REQUIRED) + check_include_file_cxx(omp.h HAVE_OMP_H_INCLUDE) + if(NOT HAVE_OMP_H_INCLUDE) + message(FATAL_ERROR "Cannot find the 'omp.h' header file required for full OpenMP support") + endif() + + if (((CMAKE_CXX_COMPILER_ID STREQUAL "GNU") AND (CMAKE_CXX_COMPILER_VERSION VERSION_GREATER_EQUAL 9.0)) OR + (CMAKE_CXX_COMPILER_ID STREQUAL "PGI") OR + ((CMAKE_CXX_COMPILER_ID STREQUAL "Clang") AND (CMAKE_CXX_COMPILER_VERSION VERSION_GREATER_EQUAL 10.0)) OR + ((CMAKE_CXX_COMPILER_ID STREQUAL "Intel") AND (CMAKE_CXX_COMPILER_VERSION VERSION_GREATER_EQUAL 19.0))) + # GCC 9.x and later plus Clang 10.x and later implement strict OpenMP 4.0 semantics for consts. + # Intel 18.0 was tested to support both, so we switch to OpenMP 4+ from 19.x onward to be safe. + target_compile_definitions(lammps INTERFACE -DLAMMPS_OMP_COMPAT=4) + else() + target_compile_definitions(lammps INTERFACE -DLAMMPS_OMP_COMPAT=3) + endif() + target_link_libraries(lammps INTERFACE OpenMP::OpenMP_CXX) +endif() + +################ +# integer size selection +set(LAMMPS_SIZES "smallbig" CACHE STRING "LAMMPS integer sizes (smallsmall: all 32-bit, smallbig: 64-bit #atoms #timesteps, bigbig: also 64-bit imageint, 64-bit atom ids)") +set(LAMMPS_SIZES_VALUES smallbig bigbig smallsmall) +set_property(CACHE LAMMPS_SIZES PROPERTY STRINGS ${LAMMPS_SIZES_VALUES}) +validate_option(LAMMPS_SIZES LAMMPS_SIZES_VALUES) +string(TOUPPER ${LAMMPS_SIZES} LAMMPS_SIZES) +target_compile_definitions(lammps INTERFACE -DLAMMPS_${LAMMPS_SIZES}) diff --git a/cmake/Modules/Packages/ML-PACE.cmake b/cmake/Modules/Packages/ML-PACE.cmake index c647c8873a..c553809ff1 100644 --- a/cmake/Modules/Packages/ML-PACE.cmake +++ b/cmake/Modules/Packages/ML-PACE.cmake @@ -32,5 +32,6 @@ target_include_directories(pace PUBLIC ${PACE_EVALUATOR_INCLUDE_DIR} ${YAML_CPP_ target_link_libraries(pace PRIVATE yaml-cpp-pace) - -target_link_libraries(lammps PRIVATE pace) +if(CMAKE_PROJECT_NAME STREQUAL "lammps") + target_link_libraries(lammps PRIVATE pace) +endif() diff --git a/examples/PACKAGES/pace/plugin/CMakeLists.txt b/examples/PACKAGES/pace/plugin/CMakeLists.txt new file mode 100644 index 0000000000..f4068a03c9 --- /dev/null +++ b/examples/PACKAGES/pace/plugin/CMakeLists.txt @@ -0,0 +1,36 @@ +########################################## +# CMake build system for plugin examples. +# The is meant to be used as a template for plugins that are +# distributed independent from the LAMMPS package. +########################################## + +cmake_minimum_required(VERSION 3.10) + +project(paceplugin VERSION 1.0 LANGUAGES CXX) + +set(CMAKE_MODULE_PATH ${CMAKE_CURRENT_SOURCE_DIR}) +include(CheckIncludeFileCXX) +include(LAMMPSInterfacePlugin) +include(ML-PACE) + +########################## +# building the plugins + +add_library(paceplugin MODULE paceplugin.cpp ${LAMMPS_SOURCE_DIR}/ML-PACE/pair_pace.cpp) +target_link_libraries(paceplugin PRIVATE pace) +target_link_libraries(paceplugin PRIVATE lammps) +target_include_directories(paceplugin PRIVATE ${LAMMPS_SOURCE_DIR}/ML-PACE) +set_target_properties(paceplugin PROPERTIES PREFIX "" SUFFIX ".so") + +# MacOS seems to need this +if(CMAKE_SYSTEM_NAME STREQUAL Darwin) + set_target_properties(paceplugin PROPERTIES LINK_FLAGS "-Wl,-undefined,dynamic_lookup") +elseif(CMAKE_SYSTEM_NAME STREQUAL "Windows") +# tell CMake to export all symbols to a .dll on Windows with special case for MinGW cross-compilers + set_target_properties(paceplugin PROPERTIES WINDOWS_EXPORT_ALL_SYMBOLS TRUE) + if(CMAKE_CROSSCOMPILING) + set_target_properties(paceplugin PROPERTIES LINK_FLAGS "-Wl,--export-all-symbols") + endif() +else() + set_target_properties(paceplugin PROPERTIES LINK_FLAGS "-rdynamic") +endif() diff --git a/examples/PACKAGES/pace/plugin/LAMMPSInterfacePlugin.cmake b/examples/PACKAGES/pace/plugin/LAMMPSInterfacePlugin.cmake new file mode 120000 index 0000000000..2ac6d20a54 --- /dev/null +++ b/examples/PACKAGES/pace/plugin/LAMMPSInterfacePlugin.cmake @@ -0,0 +1 @@ +../../../../cmake/Modules/LAMMPSInterfacePlugin.cmake \ No newline at end of file diff --git a/examples/PACKAGES/pace/plugin/ML-PACE.cmake b/examples/PACKAGES/pace/plugin/ML-PACE.cmake new file mode 120000 index 0000000000..3990c0d334 --- /dev/null +++ b/examples/PACKAGES/pace/plugin/ML-PACE.cmake @@ -0,0 +1 @@ +../../../../cmake/Modules/Packages/ML-PACE.cmake \ No newline at end of file diff --git a/examples/PACKAGES/pace/plugin/lammps-text-logo-wide.bmp b/examples/PACKAGES/pace/plugin/lammps-text-logo-wide.bmp new file mode 100644 index 0000000000000000000000000000000000000000..b9ec4c35f22ef07acea3256fa80f58b8e9b5f5cc GIT binary patch literal 25818 zcmeI42Y6LgzUcQpq>zx_d+*6PC%yNCklqWagc3p*DFdR?5foGuN32*t0qIqwR{`n0 z_bS+R-rRoQZ=Dq~5ohM!nLF=&Gw-=SChoQNTI;|5y{vU6yX4{k#qh-QH-!Ja&i|75 zpQ^az+IFVU=I(6z)adB~8UY-;UHt^uVgS~tA%H2+yGzml=fl?wPBaa_H&f?4+IdUZZ zV9ioGosJ%wSy@>}j~?Y^_Uzdoe)yq@i3zrYPZAv$7nj#wdyR?g_Wu3*fEYi1JUH6g z+Cn;(ee12a5)%{YkzXAg9OB~QPM$p3xq-j+%f}yoEcpg-aOHj3vSm3rIcyo`Kn(hQ zeSKH1T*;Pu^yoo9oiNSI@cjPwzh}ST0aw`?)4%%aD@n*XbLJdAe3(vWXXknI=4mt< zmSQkH;0Id(*NF{um4G^X4jw#+x-ttfVL=ZM4+a2}0k6FB%EpZwd0_=f^}BcPR#sL* zSNH}?85t83!+^H7Hg@~M3omq4d&mhl_zK$@84(cy$}hh7Vs36OP5N6~TajO0K zKSea?2Yvc^frqSy-~&#w8Ys|#@yNRritE>}BZKT@`}XZD(z9nzxlhLYA9y4WVFGkz zYXAfxfX|&fcip;m@JenU8Z(A>n8_|^qLVZwF(ePWb?e3=e7bq_CKxYYzMSSJ!^3+g z52d)5mzRTaCqj~k;EfLG^?LfDJ6AQdX=#ztCdCv|tzNyFuZS=GojhEyU;&Gpo15RdbqfMBfJYMk$dMz5 z4juaX>#v!DKv!2+1A@V9Qu2^~D2Fnm24-ev?BU$Gb4>5bL#6;OIXRhrgor7R>7k>e zBWr>e5BM^yD-YSpxN+lP8td>CT+l$V4ovltKFcrVr#nl;sw{7&`+(Kma%bME~N&i)pe=Hpl>WMDwYqo`Tq&O$HAe zHVkhtX3QAAA`Wl^8X%x3%|6xz+W9VdSW!^{&CZ-TBPE5ekF7~~(K)5-_8#LQW4bQ>7!N^{_0dKg2lz5L zH8u5@8e(j0+zIQk7s*4}*>xL;2DVi8gYRRrh%X-N`5QG+u+KmL9Llj?RaF&{1WxHM zT^o|f75@B0(!yVoN=~64&^#zVF1IUT{`{KqE8?!zY8x9HVaqSa6I5d(I{R_RcuRuh zwQJWF6&2AxbLPzd&i*@B_*3|f8Z{~`EUa_b-^U9U5~G1j`AdoV_p$w7cY&Ejz6mS{ z|HzbnCCJ|g1yCmfOB}X*2$s^`lhRb0_Mn?3@L~-!o!PupD-+i~!1QBO2m??4{UKqeT zK`)M4T7;Kgdg+r-K4B61S#!dK3A_+D@RgUQrlz{OIwrpH#v3&8sGzW9$r8C48H>(?yUI3N{$1InJ23M|Jfg}V}moHyt zI}Co$L|p$(^7XBxg<16#8WhLD0x}Vs@G!2i}bD zT#c_J4YJ8T<&;a8E-@YKSqf6IIQ@vg@ZrPR9)s~|gc`i?7l=^$#~**B3AeE(j0XhE z@)fxB(+RQ^B0!3-h#0W!?d@sy>(`Hwtncpb4m0VOxJyDI&NSJKTz2c$t>8!?N*#;( zlZ+8rpMA1Eb9o^JMerpeU!i& zVMs8+2N@t@3P0%~llbnt@91Z<@R>aljKfkUO17Xd1d#Mg9)ce=GPxii=$8*9K^Ei# zMOm4CiMpgE)hl`sF$n)(@{ko|D#K3v{ry>u#FgoihlE)SU?-A?m=97GxeXwq&yt6z zD5%M;lDM#qfBL6?Li!j9z8DcmNA^II5S;~ikvv4b(E}s`5o1C6B_h21wa+hkNDq5~ zgk*7W5)@&VTpnn|G`#bdPC_^&8|LtU0h}3Xct8Sruw}yP=;&z1Gm#LN7e;~{!c8HJ zcd~n#XfXhYu#{PHj7*{>Tv=E^<@f|W$gJg>K$KZF5a~e^NdMp=tI8!<3I>0}r^ z#KWK|=|&>om4_4rfX*0pEBDD?DU}8wf5o3)@(?Bb?6c1heIP>{mgnWbfdiNz9^=R8XAyP{h2J_0CO+a7<`Gmpb6UB9Q2#$P}pCmIoZ7EGEhU`K1KZfI<;voc=II^b1ktS&kO(_Ch zvHtJ9|B{F7nhLk1C~G)5IpHLc8)}j?dBJ-yh8hM%+~!v3YcA!wLld_J8#%wp%Lu5AA0e_4PEJCWgEKJ{-o1DeTT?@uiXNxuB@OO&K@ z08?b3*xB>vU!?N?(J^Q^EJdSGKimgnX3d(#JN>^L4-fxn|1U>A*29s8a&Oyc`;G#$V|U|PUwf|}CXyn4mZlXxc0C@AEcUeN>257Q zX;h`k$IjoXyKMScm{$7OIhl1-f|H#r0Ac=UA|PTMIzU(&cdPTW_pvnn0|@UfAiQk5 zf&lvCAi8&eh_dhTr$AVlbZhi?@a%#`sh4dh7DZjKP!)x3KMvv%7LoSmkAaANgoU+9 zw|YPOt{}?1{{SN2<7b3=3`BJoLTT;Hd;OeHagRV)7-<^(9ef`VN|MX)H`K=Ld`;A~ z#<*fHk%l)1I9zXtJ6x`{Hx+L1r3CLgEs5`^`}1zrO|!o=;#NyyQ-H|0*#3pO=!v?j zBtTSlfOydWVp)y|yue~_NyP1z#KED?GzEy-=u5q0B&pg%oWNpxVHiB&>k>fpNt_iY z?gQAG8l9-rUvG@B@V28_?JGc>uF`uLL}ON*C!1N4-3cNb5JLr*M1`q%}W&nXu0|H6ES|59+I`R<+FF>r%3+B_$p8%`w7kkG%7?7^FGq*J{%5t^3 z)hB6hWwe!XHzaja%+k1i^?dtZD(rK65w#V zZ|cfkq7aWtv#C?P;|7K}ckiY_CwG)+@AgY$3Y0+Y4^%~ME71YM#-!U5;Vuu`GG-_G zbOVH`0CBP|w#ZWmF$6wQ8*{xS+11RLPgsQe{ZiKz3ik+zdC5LM49b!qP=Iy$VJB*0 z;5PdN#FeIm1646lg@3T?bnmzq5_|*}rba7rgTHOhEH`L71U?CfKFQEYg7~su>e_+` zHY2eB{XwBFV8MVLB@tf^NM{NoQ=BdLS4Hh9(@QKM6j;2T7Jvlvb!BewckNlF-nNJg zSf8o`M2ZA~2!P7=~OqTTwIbI`V*2csr*~#)kW5UVaai9R9 z0P%HO#=`7iCU#o1N6chKkahR*I=6#mS`0$4wHYS#y>$Oi^F!HhpjCG$w6idb9=L&0 z6?)hlER7fu?&57>3c*meeI*gaUN&JiW~kPNypUD7!OUV!EW^H%@Y(TRyt|v53=DQU zP#V$O&z^~l{B5%DmV(fDM+KH8y&vzhU_ zp22H+1_O?XIy>{vOTu4>^TN)%nj5zTI~^>GK-Gb00O13O1V;<@BbZPa_EBa4pI8Qok3fJLdc)p8fq$&YKL+eA4#y;6Dj`%~0|?Xt&@lE@1Bi4N zt3)SDaNJoGwyP-oj~Ue!IYGZ4nlnGu57t7_FDmp$YU2=Sa-B4H+e5W+t9yk)KgHG- zYjCD92?NEQ7>&94qO8Dg+p|V#U6}|yj@HENE{lY;jKqFl?UQn}I!Zd9H&T2rHYbl| zq-l2-JF5-(VPCanNb8s5W_7k9VSRoWdz2vV4@m#4FdVVwAJX)@A=%^fZW6?$hWH2l z)6fK(Fzs5O6tq`}rnL>+e%O}zW~#8v>~>d)_GoP!i-Sdqr~S$L`0LGy(!Kvi=k{HD z=H?=yatz+kE99ra*>v&_hf&Tw<&oGX#l{xPcBN0siJEAv4_{wT_Px}cJf6*%nmXEA zt;-MnW?&|Q$){{Ls~dfiZ!{-L0zaj9!%}Q3)*2c7%lf>K^G!)GU+Lc6$I)hcseWf! zBw7jxjQ@%H1Sn|%2y1JU^Q(aw?_~tACNah5Wx5{+Wwitd{{o2HttsF4PeCwgK6+46 zBtG56@}<;3m@q-_4qd^U0K#a>bj|JqCevr8c{|4Xxv2{lsyp`D_UVJXxIWZd0MWN^|4`R>C(8lBPWUJyi5F7?(U3_|9t9pYIPDR7 z&p1bm36bu}&X&+v7Zs+i-K1{X=2lWPQtt^CqqVO1lT24DwAXmjRDs3J+1Y;1jlnK- zJ{{?v=wvZ7(KpG(YG8=d&`{@I9yXvaLGWHkpyThXF<@aidQ7#SL!q}lfWQLd0v3)% z1p6WVj3LB?g+AEJ zJ^l+S*Bj%ARG<@0;uU<({xYr52OnR}{v(=O4>VsK=UvIo)0{X*Q(d}J(P-4Cp4D8w zskwGn9VIRr_6c;n)tZVln;>%$I?bUIV&aZ{9Oqy;cb4jIG$nu{Bh@$FWfpVQ3Q;CS zSnu^qdnZlkzfw@7IeA`ySh-%&bix&Gmcg z+wZF*o>YenSGVrgT)w3~J4GEkUVZ8r&GECEV`tStL)EcQMP?&)b!id@cCwz!QlpeNg zuH059O+!Ykii=-Q@%toSi)mtGXyAbg{p5H*gdR;pB@R}{q`F#T@$51)G)GUvMs?^D z>bR#pit-m_1*Y2n>G9NZvbLoa=&p~zA6JU{+mAJ7; z+Zy76+%b1zln1T>WKl&xtj!BqQJ`faY&4!VTXXe}X5D9Et0Tv#OI8Sc0rBJ*n%E10 z#S^2{@z1yx7cR~T{vbDus2dZ8LLRS)8L9UGU##BG*=X8LWQK30`d+G!!^|V8gk<>X zwfW&%KX)Z1O`SMZbMA`f$SHO3a3v{4UA#hb@w&QcyHZfBWan!3egRL^WowK~j1kr? zgeF-*ZXp3;|pnC0S8;^Y92~)g z-m#b%X*dAE#G+t#rDrd-Pe09x^P1BaQ3xeDRh|8^=KNLgRVu5Mm^h)Umu^B>GcQjp z0$8wB9Goz5wr0nxA}`iP$&?PDj~+JuR;u5RL$W7C3DZQbu&!6w>in=^S9?VtrB0qM z)c@*jwYgO>F;SPV(cJwSyQ=sHXmom^0QbI8H*RGj()?Mm79M(dx++o8>TloF+9@Vxhl~y9Ux9!P{JeF_$x_1 zS6h;CHH<{84_8OuXiX*ZpowQbToXGr#?zFG{V;0Nb~b|zRP5{tK|ah3T-_@y%-KeX zj8Z2|#54$n96XFQ;o+GE!iXRiVQ(L01%5Lqt6z`+fu3(K)h)~l^73{QSj?L*Eb7G@ zN?txA@wB_jqeN(;)eGwfE5KseY9`_;cUMFmtBxi!00eIEL0iTOL%v1iL|}iVC0Sx9(=8Q|gTV6DFY5zbJ3^IZ%SMx!dk4T<;dnT786Xlf?H z9Io@Q7}%~p|Du0-(gzv-cmOPhr=u+nO>^*=`r<3<)02z`4ki&n9I=)V-grQ}=D<+~ zV1d=C&*@^d#QQbAc912MQn^P!q{i*{M6^{ON)ue!Gbk?9jt^X2`m-}EXIs$2=@TrBqs~X6eJvMo4sM> zGF+{ILK2PR6<9dfs4LeAEMA(2B{FIsJS@!l-85ngk!_gvZxdLo-l+cODRs&WT~Z7M z0YVla;)Jm{D{_Mf)bc!RXrh5{r}{x#P(W8vm(oxVM2W3t$A-;}^@>W0Cb+?2X|N-Y zu;ADSEQqw(RT4|NTYr`xf?Pz}_kfd+7|4J5ez!UPVgFQF(jpu9sxAFURTK$~;^z+r zLaaYOthl;ani##85lA90<7k#4|2@+?j;*l{Ap#lbmZETBH)7*3yka8CX=dis-58a= z)hC4l0wYCCbMs4_049alh^Y8p|MUfhI9gcd(-$>&zfnI}taR(f%KIy$uQv(D!bC_& zioLf~D@_wc5t4%`hB}SfJ``;i`taNfjD$a@8xoIJMFCoIc7ZBlGY5_-ZtmTUjezy- zzziAFkf5BckH6KD1Ra=2OheqTttdi(h>8)B858juJ$gV8oXg$5sUlMWi}~*eEUw;B zi%P));l0x@?c;2r)#(35k#J;CzMu(+ON|NSG;p3KG6=q_^Fk#SxCxpB*kaA*R^fW? zevQ=7q;zzuA>mSeY-dbErb4vDr=LG~gJ+}MWmpXc0GyrRT_5BEy(R~K{M?CgKBN&Mg%9vBTC_xn{!`Bq{hCa8 zwlUmeh|UuNj|da$H&*AC=3<2p1Y)kc^~~geFk3T1{_uz(bZqDvRMGMrqx^ zf;w#l#gYln;FHzoW{cqL%>}tBQA8~m1qctmlr?Jo96$%^0%&%kZ%hDf#Rh?eTV8Hks0)i=V+maOHzdpj86;~VX(OW^ zs`DfgLW^){WT7PNBw=Jfh}(z=H-Af0Aclqql3R#nCrrdRTa5k9(+U3l!$snS#F0zA zl^K-nZiCatY{``S=gcHj|8hXuoOo}#k-5W_`aPA=iR97d=IYGZsEzR4gNE`ITramI zQ;k4Yi5m#IZnUPLBz(e9kPELbhzM}7LIc&0mx&nc%w-geuXrsoSwa)mR7%Q)Kg2tI zyo^s26OPr!;z(U>EEEe%yesiAaW8QL@`}n`ZB8OYU?g_+P*v2$`Z$^7Le7hgi8xF% zb2G)=gFsQZ?gK|jhNyFGEC>S&7=NeM0l{BCQ^C4E>4645(^9mSb%f{AD{s{;lVXnp4; z`zD2Wt91?Pz`-J*C32rW%ge$v#K!F1^Z=0Vo}HuiABeVy?CXo;&Yo^$s@U5F=>frr z>5$=;1qCzWz4ukcB4{`t_(R|#@GGxW`?aYn)(Px4ZTE0@VtYsp5Z!cPYQF(^W|2dl zzh+)g$UaenkFtWQL)-{c)z*FuTF?D8ah+Jak?KEFV!@iT=L+VZykH$4$7XOh3$p@K z0^QZ#jo^h%5f=5C$q2Y>e$VM~UKC8sdgZH6j7~_U=|pAiro>W}5O z%*&e;>&^D;v$F^^f|FuiO!PrW)v^ku?*L4Rh@$o%AvA$>}_m}HXRjSvJk&xGJPmaZOtJ7u*r?>YD zwWY68Tw3gH%bIXcq}8~f{YORk|KcmCuD!o6=Ym6k2`evZxz{N2t!u>b5;%E+sA!vuTbnGf&-3l_;hs?#b*m6QS$5Z;K%N@BvA0gFw-x2G!!$Cc(}>C^?C z$Z1YqP%^SHn?%U>+cI%G%tNtBSw&1U?rA{8csd@fi>JnegmUXg(CPlSnw|S7AQ`*4 z%}e%sFfdbML1rx!{^pki`#>xUcDvM)vO3=o(}ad&lbMK*QbNOQJlsC%8G3I(Mx3Lt ze(Ec)i?qp*a42CB!jBRCK&Y5lrKqGM-+JpkB_zz(+ieF}v?L?-Vqzy2DQQYv0^U#H zyKWO%lv>{;GFU>osn3Ch-rMC!UEJlSM9wXkNGa(1L0J@ddH=;DN+6!Lq>z+~Fw7M0 zu%$!~ROjq#YSg#hQ-3o-Lv3)wW}jX;#ol%VF{C=s0HsZEvZTC@#PeS0WsA&Bi}4s0 z>1o-oKara{;aSbD1H$pooFmeOS6>&=48@!0Ut&#R_jc{KZEw$UCjd8oA>OM`gr{-) z5Rs8gpM}0LQ5Wci^#InKcrTyaOm+U->d4WQi>OsP)l@SP&+~e+PkFeP(KC|>N(E_A z)OoKbdplCwCYYd%=}=KlFicHQV6kbtPhlQaR)m+BFe55hgjPgC)M@t}GJR%JhO0Hv zEQvgIAj_s^^|x<{;=t|$1Q~%*5ybd7qPdCQQIR23FsMSQE7np{z}}MMsZWljuBWcr zfZY~2KKB9&2^QKQ?=V|)X!|lJ6JYVW0gKPJ-7|0J}{8t$LCcsGHy^`cv(0Z z;*X(E@RcO@tAUvq2P_KFz~+K5LUlU%MDgHk@3>Ekv^Z6oLw3e56l78*HGsR&B+`gleQB% z5x9zpyALSc&2T&WE21_P>v$0pKU^%ZxO7vktf7fDJJ*!Vbl#QHiViFmEfpiD%@kS< zq3Rn&F=Xwh9atobTWnx)vObZJQj8oltOE}9MN^_HC_ z5#J3=mmwXQ4d)i$v?j?!jk$)06MO<&9NOvvErBRk0}wUhJpxF}hDH&O&v+i>Ff4xQ z$pkboc5!YLRMgs?l$^hy_qOfIGfS*USo1HPaHcoQZ ziy~{D`W)psJQyG_;N%Us`~rU`2uw;Yf+4bjmFwdIJP5ckK@g@?j^0(3mx!D6PcHN{U5BwSKcms$P2o4HpH<)f=J%+%pWx#FG&&4!PNXz~bl`>z=uYm_?sf;g?={#y!kAUA)?qNEpFHEb6J+m=o1egp@Rq%bR_YxF11eplEfl zPKe`*wWyz?x#^ovST|tj#Mu+CUTO>A{4VoM@3PO!o8yi zEVq>CD2-xIIIL6GY!os6p_58{f?{UQ;SN~^;WYDvCpmpdoP|u8PEwEAIZzc%$(O@y z#k>dm7wWO|a~!p?x!G$eew^TufpfW!lw+Iu7U^9Beg6{GG3|{~5Ja$H@tyjt_OLV?i(Q#3pL{T=e(Hw*bJ2~TdrM${1EoE-9-^#pDLKF7c4K=1T zg7c~At>hQhhIwo%($@Gn@X4&8Q1B2t`NSxtsx}}hVso)}RiT#n*}=w=ikR38p-Fiq zSd57AK{U7$0Ci3J4G=aBYfq3|T^Ah@up~F+xp)y>+j)5ai@-&FYXOWh&&YT!Er86B zN(FJf@x&>@zfd%;YrvvrhkC8*6*gS!&P1!INKxP+PMS4GDXVZyPx~k*m;-eP1viY| zct-?7ct5ZxEU6Y)MAQd3;zS&~8_iGk-%+YZEdYVNDXSeubJc;ayk zGBrlzo{}a9MvhTBwV_#k;U!@rh@)d-WpunWC%9*jyINkU^llV6gqm^WXLeE!S0bekBag#&dVot z5OETz$+9(W?#|@+^HY2U7SR!EV~aZaHv)@8Crrx9!50HgMXV{@o%}|vs=?r68qgd& zGZP51C^LW{+?n(kEI6hG3r-Poa*$ATW?iq)f)EdJ{@KtZvFJ8w8txa;GLeHPn}m3g z15>P`j3e7rX&exgw6>Ly|uGH%qPeFz38$Jc3B zWefw%EP7z@Mdh1hh?vIS9&y{49|jiU2BEvV@P}y5jr-^usYz{+%f9MZF1zsmZzPVl zMKbiQ2(Wy7y`1fq<%NBcCo(#L1qBBJtjo8kEwNQf)W>@#hzP?;6c#jRE(t7Nd7W59 z=Vte5iTfd%F$ z6)dLB6cb4Wm@;{qxKXlwk5$`1bl531S%6r&Qf!qHE`>@)F8DAa#8>NT3oL=f%-Mvd z-KNec3v$8zk{@z}U|wA#u=wC(0vE9*#_ZT<^y1to4|_ikXO39KMHM2RB`b`^jweDQ z@Zx9$SJi<9iPxOD;^>z+Y{x!si*#VIVGGOJG&EHDIdYH(Wtd15)i1<_LMw+KaIz`D z5!?HSf&7;p-D--z*P0CNX>xk2y$-W?m@8fL1tj*6$2I~{p3og zxMEL(=5IEAAvss1^k#mc~6?##S za&{I$H6tmay18-SDhwkaIJacYG2=Tx5YuqM-0q>HeOtm=m4<;T}2<(7KGnu zN#d*@5X7q;SQM3TiA$JbKpZ+jPQx)KK0<(?6x^*F_h9x`Qs9jhMd-6V z65uS$34S)-k9alF%h7n@Vsi1kHk(+^vBn0e@-AWKkR)_^BP8GfY5Uf9Srtzq;L!*5b zKDR8xR~|(p+T#!GXuDIpzb}CMEgL&kCU|43*5MOcSv# z<_0XNvQl~j1lVDECOnH3pq{9X`VDNfZ)}*8;4>pB0F#ad=Jw~Fay^$;$Zw$k&)Fzj zaFXO;hT%94Kf13}OOTu5=b}VtF;JqCb@~$3MFw+#a-}&DN6R~r3Rmu~Hg{Z`2EU_~ zk)KlWcXLpJL$F#R>N|W=AqI<$6EXhfTi8Y+g51R*!T|3DqT-LKBnDfO6GV}l!j?G5 zhC+J|Dm{BC35h}H@K1ManOQ6ex%q!EBPeop#B zYJA+=73VZTA>btfY0g4kdsE;$?rC9hh>ZvwXf9vNnwl?8D3Q@r5-4sRsg11(^AKzH zAJ_q6(lpV0b-uVlLc+lfs|YP>Nos=dDjwo4#`<2N+^QmPhfvsm5{K*c9fb>e9zE2^ zP}T3-GlxgGF^TYUOJVr^{%JT)B4TkvkwD?rmqd4%6pCvP`=`B=8AOqW9|4eZau!?Z zEABo}`8rq`dAV8C1_>I;tThjQ5adruv+(o~A>3C#!Vn{Sd*fdDg4kbvk6tknr+Th; z94QuySX=f`Ki#T%_#?dP=H+ds*9)dS{6XEYg}oW~ZVPISTIXh z7kDB-96rf?8e*DNc_H`vi!1B`i)SW@3l4_Ts6`Jml_H7&aoNbvuZLa-Zv}{rTaij* z?ul>@j!0$HSoVW<2@qHBDCwE3$+5&YZRt;F-6$ZL<`;Bev1loRZ^S(@s-~Fq{sS#d zjYUEWi1SyCf`UkoUQYD+rY(cBN`%X}zENNSh|%K&7VuDl$jG#Gbtdx=Se&|O;^;`Y zD=wxF%p{b6_z3&?`q-}rqzO0C@c?;uQP{>_A=pOwZ%0uW6*-0w#!?tqnjKW4_vbd0 z@vsqWpAtNtlL&^`m3wkr*AX|N?aaBrzq>e`@CZ+gL~yr?BZt(aNKBS#Wi??nN6W4R z5L0IOWTtW+G&MjlQ#IG8U z7zr#QKwWwwY6b|BswvT)4uF_6O&cGHNcN5N(FhP@8x0^bk^~6T#wO0xz!!W z(~xWq`gunuPu4_pZ(G(aG3Q*xJT4Cv_(^7**YAg9f07%*NFt!xVv?R;Ys62h4J|M9G1XxTq_!kMHlTbJ)4tS`epqZ>QJ;sx2 z^9P0-R)qQ#x;jBn61mctz^z>pFGg|}ioN5fDiXxIX?}p17VE_)Kpd%zD^1km zUcc09&57s)O=46o;_occ^8Sm5v~5C+Hv~f>A@hg`*AgFlsK}K8;Ll3*# zr|sl89}-fL4R~0S6Asn7!*-fXd@9N_&6Q3k?vZdBIVV|MA0jk{X@tAuqs85x(GjkY zZFsnAxvvA&U&F{AGZK8c=QA?Gg`|t{XllH;1jVjEg-h5&wC=?6Gzka*k?v~E)i7!i zcm_ZqK`ep*BBp>q&^d|(7eEl6(@7Ki!gyR%^<|I&Lb9qcbjBaa6dwC>-yESW~k> zb*bj@3Acv#Q~{Fxei;1&T;WZjbKcl)ItD%asFn8^P5{n0`L7I+fMxrj0f z%qKL5>=?WdNtzsH@oO*nV>?s=M}Vb3o%n>Tov)9()|3D%Xi_!5*FW`GMF$A1;@1N+ zB?x}v1QuN4AVXp#e7@c%>0E8ckL{o|SgqQ$(t*WS1JdL@5q{ACxCbo>KR>r%AP*&E%5i;y#a?id{DkKFf$8vsCb8}1 z+NjUUqNMsGqj#DUrX`3|DjuBYHv`gg4CoRJ?JWuCr(m*7i7Nq-s+m=p+go%W7r>gY3t74!7P0H$bn&V$i6|CUlTn~%NQ7!La0SIJDVnMQU zqdsP3q0TT+obCalZ-_YF1`AC35A7MmG&BiPkfzUTV&&fC`2XHt;eh_}pZ_zXzdqu+A2+MKcO8md&mT(7c^~saT~k zT3R9@Nb{DlQE+Td9ll5QNg?{HLI_|(nsBW!_)M5%>^!&QI;VdALG(K4cw}^VR9B9K z)uKSP-6v_g<8jshitqlQer~CItN6Swc$@MlN~!?@0EvPH zyE}7h7*zqGyF94UC^wJwHF1k+eUfxXAMXKwucswR3R?P}ln|k5gZ=m1fT{O^rp6~z zf@l{njjtYe(kiHko*!!=o{XDa1WH4V;yuP4*CvUN6_oJfu)rN5r_rXIc9~vBES@3`urR+u5d5Ztjay`mEdpDPz?xaO#NE6@v)??02pDeCUgq)ko;4 zTdtHM)-&UztXvQpAa_md8IqwUx%%{gb3k`$rVhE8JnfQrbCKeUU;_vc0?Z@a z?*5G5b_p#$lJiuDEmfz@7CzrD!Mi4RS8+p#tSq~7q=c59E?04$$?Nr+C?SI3Dgm#Pyzo&wbAy0JwbNLu*~@ z9Vg8ri@Iqgn>dFIxvMS6wi3)k7&vsWYCWZK*=$S~TTi@8+PZEnjQ{k|Eg4E(iRi>X ze1yM6G1?5ZznWYdSYKbh`<>UJPX2(U48SLN-m)xtHtmpK{~W&~ftXP$g@o~CU#x2ke|mxR6#_T#6J3^Pf$?Kx!C=W1eVn`acb*}YSj^4sZw z{PX*@4BtLmPe<4FU=*}&hlfiXwI_wr+@KJA+gICzWsrcIe>G%iqk8jvvWbL1x;zy1 zZ&Zdh5YM`MXOq0gAGCAv&tr@t4^>X&fIaaDu%(-{rBt{d;$eNE-odnu+JG;-4=Y&{rCRt`}x$J39O@tX4SKUsR+^UQ4(<8Z= z2{nbpWAm%7+vc_oD$<@PitKdIo|Zt(IF2n}c!9rZ$@SdOQ5R~(g&D?v*7vRE+?LD2 z$DYqxpkP9wMO}?tyKS^uim(Z%9sD2{$=lj5D%~`rodA-dgw=~0U4rL=X-r;uAx#-= zq4Nx1QuA01t4XRSS>vF3Zrbo06aqS6t=EAwwfJpwhd>gAiiN|${XbB#K2xCgi6oI! zZootLV~V`ZK~=!cLR?o8f}|l47S8LL; zqk=Qbl5L8QOAZ$sD4hT^hNqKVNS3#WN+$6t#f-syIr3NUS4^y6hj4wO(KF z41-L^H_{q_o~o2P?>*?dEn+7fl1l2G>|RGz7{N^LLvT#bUW8*_`Q!s{^*#d`oqSXY z7W9khEqO|E-$%uIZy!UJk()RWX}9r;upfm@Lb1iE)ZZOAy2{^;{^-5)>{GMRgSS6^phC9P`>&+BUC_XNBCaVpF`@0(4%AdY^LkbVfWK6WTu zc9=V%bZiumKEgI63U#P%rxV!iiC&5sTyXv}DYkNO=9pAHTDBzaQ4m9>);1(I9R9;M zsANL5**G9>?Y&9+@F$V)anTt%A@PzxnP2?V|o<2KzwE8kI!Yt}+lxT$87ez?Oz%?KkX;)v_Vz`QJHt#8|v%)N% zrxJ~=6Y5^~0!ww{p%ZE;D<~iUv^}qE5jb9hJaU6hrj!9dTjHAT#9~T`B)(RUSg1Vm%n0E;*z!i|THhv|0dMzlmRmu4G`B z#dT0Z|IfINK%j6IjH-azeShGUhxf7OaEn~1uV!8LeyA-plpzoE?H@Vi*=TSak!QV} zpk;%gDlqD5X|2@&_dTHe?Golx$d)?KD1c{BtD`)Tq|X{++xcNBwp11x)*fn~ApAwt zd`-65C0Nr{m7n;Bv?7k}!F+?5sBUwU&){c4L_)B87?wc3&H00gkaqz|k^)_#kbanu zJ~63dCCn{RITxlK+)x&+x&1Zv0{r8J)>~9-0Ep{g*+z~E#bgEB!2|CaL~>YaZEcy9 zQycCx2{a+pYA;Ppq)3Nh3Q-OM#uYW2gF22_0f;$UVg;70l=#tLWkOkgZ8W+hGh0p( zV$K-#)f2!gfC&r>Aj&^EP#|LsX5vsE6_k%r5Wh(#tztp^ixn0+Dyr>Ya z3Nxcq`Z(Ihpx9_TuvF>9LSggot1x{z3TyP3gKkkC$*<5#WNpCvC1dAruBw?+ zEXb=!MtRl=E|c!QY)=7I+PMovYoMX!TO${cG42>K#}BG@f3IHc!)W>F1$a@~%v5x& zxidZ#Mb!^_T|~;^%4dF$!(WiIwp^lMw<3>~b<}xjEQlEx3vHAtLc_1Lb$64Q@G34H#16M-_3ZYP+APihG;~npkPhLce*j_?38bi}=*Y}i z#HOa^mebrZE}7sWMz5-`FF?EzP|5f|U#S5?-{HfA4EoV*Lll`?aXQKF^*=>809bfd`qWFr$a~?%!q?p8P#l~Q2 z!HrbK1v2ynfD4uQWZsrO)p&U|m)O>p(B)90qW5JzFE6ZL*cWOCHwy++m^c0`QsImr zl_%qA;BG1R2TpF2HSMq_wu@Oum3*U5)PefEfGd1vpmmd{N9DvVT!`Ph7X|>AG@e1Lo$Q~mZ7fDCjGPo>O3gnUWtXzxJ}6r z3P`)Jb?ChsK4D? zp&!ms#MkBn$&v8505DM)6TQAiFFN6pbDB7``)9)ogTK|++&u`_zx`QVris$8Y=Hv% zK?KA#bIjs9GH5Y#EzE$pn{O-`YmIkmdzh9C+P)*MA$+OA(8t=xPZ?qznjXh#)X<_o z(dFcdpyRF{iR3f_r$(!=i75j=#wKHt;IS3+a7Y z%fe>$gqlPbzBE+Zsbh4q^H)|C)Y51CSN$~nI5RG19nCEoXRs9(l$s4iqE?R|0 zu|>&d^Uv5(qLuF+IcuLgzaqptEnp39vJ5>O)T1*tc30`m5FUO3y0v7 zbJQhcnX7cAc~o;7rJn2l6lI@K2_&MJJ}*q~FstkOWqKP2@H=uH9ixt~ea{sh>_|mNT{5LXWy3`G7 zn1+0Y2Ufu@^`y|ko4g5o(dvfJQi>W21+pWztrRmE`m>uZf^V`oPA%y!F%86VN-%F`Y_%%djxK5L4mzZ{E<2P|zd~Yw5cIh32aFs} z$N1~>yB!_V5GYKjR(RR?Eab}_B_g5ppBbGp#neH8imksj(qQfU8&>tC1gIb}!p7*N z_XiQ|WIml-Uaz`y&8=eo5FQFCe zGQgcmo}1QA!sMQ5e6MHA-`009pS3 z8Wy%;!bT12xxRl$ZM1y89nR17USv=2W~$XotDlG!e(rI&F#k;Gi=H=qA9D03doLa= z!9XLO$_>l3>u&9bZe1wVpVER-0m0>AM<*TGJ@?{|*CeZL!Kg$?1IV0SeMZLUHT!!% z=PA+(UqPO=8YrcOVgXb%t4+VQr>cT(NF$}}}0wkXpq07+baf#~-T}b;h zL~YGK`#KDj2zq(Dc+>pe@Yz!Ao}XfRB*v>Pta&S2w+x@2CaJn80W97(VOvizK0c6J zI`W&We&mw~t_}n?4bg@BzthQT`1hqnQ&m!O>8Ww?rm(^7ly|kqQ2epE{MCy?uz0XD zSa8fju-U~+__o*W?%QMYT#)nD`!)`#mE8{J;}zv!xDEQok}b`*>tpg=_OJjY=~WTokQ_exJne|*XRm)0 zN+FjiTXOXC+jJ!2C~iI@_H`90B6MXJGY7jIx#+C?t?T{AsijtA`m;qdjR56Gh5#3q zPI6%bZ{%Lt?LT*<-3I^IpT*O~f8H~DRI}+1EZ`t4^-v&IXP$ui*FBJ+=KE1&Vwrr@ zPDm_P*gNtl=H;hK`b)v1GhOpFg=dllT76vev@^WXWpuGtdc>;$msF4@xzu;{)>+9n z(As)umTu7x3z*rAS6~5CnKtIW5H3Gko`%1-cwDi#@Wya96g$%u?`Up25X>vj4j&^S z%3V+OKJs!R+_T|2667w;!N1fjU{3}LP4z2b2W`q52YHJ>>Gk4-fl|FqTHXHDT@Mw3h(co?%r4;tv|T& zAU%cS{nM1$B_hzZc?T@3oq|&U3tDSk{`5Np#!dT~P*S*h7-Oi_z9f$Ha~;WymEA_` z?v6LoGN;c#9^F@=bztm;;iTuA!LqJgo8T`BHb3&pWk}h_H*w!kw$&Wg|N4LHhtN;; zK&STe%yHVwTS^2zbU%zfVod!l(Vn}KVbkry_P2KsZjK`|8nF0Y#Ot)J4)?v$?SimM zckhV-fc4*mW_L4Z@w>r*yME3tja74aDAFY#^V&N*y;_p%VOyelbtfQq>{wpGU_2}N zN8xAty6-Nvz+Cm!&?LIu91C!2gf3qFj2*=cTx-FnUO zDyWz3IYqNYAot7!xAUc0A)A24RM0bGjla<(G9goxLBBf_V`6>l++&0wTI*o1p#rcs*;{$5w%f0;jtPA~1 z*Fo_Zn#!^iT)%;1_Ub%ye-FMke9!6hlrD<1mkux_MrP1MZ$nDQ?l9NGfy=4 zvxRF$?NS%w)BZ@s=Wx)L7sNd`VO$8!l3FvpxAT18UsYNiEp6#?=&9UA10dUZYTqYn_A#WPC^_gXx*4|L#%wH^2aUKx=gp(Oia) z^clFA-6wN6KfR82#lmWo@F|&a)@&|tQfXlQ2uN2zFD{D`pKvCp@$#$D6|se6 zE2Y*n@BqX+=8?gP9Qs~F!P_M2sf7}HVPzvCIu0jNgnsAx+mRKh*dE8X@ zkkSLgndmjQXOEEa3PkCbPYnLljv6hJtvsOiMO*75oMszUpB*J7Jik1CS?td>WmaqW3Pnqn z&O#QqbYDG^P?662sX?J+XQl0+i$gM0sZ$yr2==7gT&`+NSHmKqWZZj6&zk{mpKvCo zAzQs)0$#KmH?(^(gkM>wX%^wvF3^zu4s62$8LR zju7ProFRJEKV;mtugPLHY+atd-~An5PxLnN1(R18j4nn? zlG4BqVqx#HQ76`ppSQv*J9hG)Wmv!;GI7^bRJ#+qukkufcN&0m1A~MXvFO-Ln%*)+ zX{6pXRuMopzZ%yk)FQ^E5Gz7fhVnfl>~ZrXdM)}HYt-Eb#iaO&3F_dWV!+wvIA<4S z0fSh^vQcS_`z8s4V8y;4nan4?Wa(A5(YC@7|~uZ-!yLol3>D_Pxk;x?tcm+UF< zQODy*!&o|H_hT?&sZ4e$DAX1cZo#xcr$5~OslV!w*yMM=zH8?Bd$}yZDLX zYChfpTXgkosn<*A{WJw(`#trhRuY4#3Ttow)oEG{ZNF*&$rMOh>4zO-jJ^!W3{h_` zUvfP<0ixS}NM8^Cw<<3i4H9L=dN`yG{@#6EM5MJFb&+l8?&NuzHE%1~rBQ@qb%1c@-EBPv|;}N9_EoW5g+aK-OQYm_$`=8)LCEt`1K3B#(uDpo>IwC zqQbn52yI{IdBr#_Mu3DrmMqb-cL<8De7$^%teh@AO>VZH$62Eh-8e!-CcwYsGhiBZ zgny{+A86`@#Cx!YF%gX@M9b6VEjbf8EBVc%Kl)_ZjdC(HB{@sKFq3ggmqy%s!G@K9 zSKU-uVh7dbsdV^P8>wCisp>aJ>?p88B{{|*;qOaR`)=QJ76d!RXC7(U- z%hX<8r(9bu$nt8x&Yn{ZQviT81dJ&{*wL6Yo9mEtE`44*$qAZi`-ds?;z3IVbiMlBmErAB;jf94yZ`X6q_VjFzR~)r~Nv zj#{k5$4g$}EX3M)!B^g+PM1guNTN0XH~0>OMT|s5sA^5|L$Ob}kU>pAEoh2j48NQ2 z!*BX7$U`2H=jU}`>!QWQd;<))r^xLxpV`gRNn-^PTrl8wb$`Q@Usj+`YG3FJfLl0x zKgQbTWi0{sroyTN>(CKqbRfH53egShsL7#*s42v0*|48G_8l?ooJIV7X9*D?T_d=OpxUFrK~CUX<@DhgN9jh>oN1o|QEIO9j_l^CPcprC+ggC1H{N!( zprU3Q#5>7?rQFz!lRoy2%Zl*S`h_J!&+ORaPnGT%ohfS!_a0H;wdTzvZay!wim?+q zbnXme>b-JLoj#9AhSwxb_oj7e?s!b27l!ihkFxSmX0y5Ad*XYm52~C;Q`US&ws47g z#+E+30(-?d=2CQi`TCD$LyZI2sj#4lP1VppzaykvI&?7&|HWpdj|D5|vm}wEV9L8W z>12-CYPuom=ON#b-b%hPG7&L$e(g7PTv)AT0vZ<#b$+dSXRH3VWu~&>f^@qJoK5xEI!V!ib)Q|Q9h$3ijBrms zLzKnt{nlF5CixC4!~kE}Hj5W843G4%ryb`v$sBoRCK_()_d`Z1SUH`dJm@rIL<*zS z%#!D}u)4IHD5i|vQdX*m@c_<#DUf6T$K~}S=Z@K`N(Frj{*4s10kuH(fQ!P7geSI{ zEuH2r#^h;hkPzk|iF?NnFxh{yZ&h_L zTwRTW<~OP2#2Z=_tGDy=k}T}-faw8vI@Xr;jsu4O(h)?);-4~Ayi%Z$MS|AyTamNz3azhfbZdfeOUo2;268jQ z`lNmp9P)RM2gTgBHKiFFuz=ZM`zN!KYw;oerJQaJpnyWK)!2ZJXv^r?xTH;&Qa1c;!%P-ms_@ugrUau8+8pZMpXkcRtDFzMs%TT%=ab52J16 zmz6L#D0q~A(-s;>A9q>pnf#(9MAT~r4~0H4IIxkG8U#EKI{g0CZ%c0TSFJ%k3Z;ea z6yq!tESRTjzP|(0&P#{O$4c;-6gf_?=GKfv;%|qBe_I%iF{EQZNfeB)qLI^vf~cpx zELY4{D!11&5~MtLXZ%d=F{IYJzGF=`xIJCAyGM?U2NQFjvIjF?6dW3?{5VXl=V?A! zdK@`vclVxa<>5FQj9J$9Cu=sqt3>5qXBc5|UabQztETr1SYcx~4{8{{6{dx}j8b~U z&s|R@t=YRU$@M-W9kczb({2i&AEEFL@KTn2aa{CCP6f%7+sp+|F(~O+V;8{63`p9D7!qNNBn3tJF#C`RDPf5;5GOsMff32UwnIy5rYr zp2pgA;bU&!xmE$5qv5ve`-52f`AzFK1=go-G$PkUtjU-6(UxBq1cbxlmT%lkvLJ!N zPou^2qbG~$?f0|=wqUkEaU7*4>QB=0-zENC%LBS9 zUCHelmPB8d9BwRK989yulwVp>VVp1NXdv3FV4R=5s2-->$wLH^>wcq3lw>pL;_6V zt+W}F8QE87Ox($=WZXy=tv_&$vP9F_)_nFi`$?kyVeTuh&@xv^ZuY^$1X5bHuw#w9 z4a-Qz3N>^-w86_NR5VhxTRz_<-~Kzn{j38IRPnw+;>bYXYan=#u(#jusSzo1LPAgr zSMSq0x$7Kc_s40&JY?HK+dsKQ4oH?DY4r5zZ%&7!ww9KPF67_#EK59kL%lG&Il~d# zDQXAC5B?a1{HALrJ4G6`Icid$n+_l7;kdZ67U-&G#BL&A3Dn-xR#}@G{<+VVs&l)U zAeej7T5Bbk(w-;Xl~$I^>Z0dx(wMJrfrqwI?$_rB!8Qm4KQDi!E^eIOyuJO0b3SB~ z7(C1iUo*R8MN+aa1^4K#73^PNL3?NjBp7iV$K#A&3e&PElmdbq05aGWON6DUto0qN z&k4`{f2FSLJ@xNQoRe<4u25~&QBtBMTp6;&Jdc_o5~cf5Ozc^W!y)d_wtPP;@uz?M zol?hZZEiO_S2{tXh~{_v2ps?`Xts00dAx4AK;KvjW!&(o`yIR~8=nr83SLz}ca>SL z9EtqlPg|CT#k@E)%LuWny>r(;#ZFRg*Ws4nZz){~N?dXyG>v}k+GfPL%9f3|IT;*dMWEBIXQ>lOlwpHQ{Ftr{n=o2D3V zdwNG-ojzww$1@GPg3_Uu5w*?*?8yHm(zNOEZH$IjuT-OO#!y+_gf4#|_$8ubx^ zclXG%i+4H~Z&Nn$%c{%C#%aljX2Hu<6>)A?Rc?2Si~k5lcGJ=hD-5r1Un2;hR#vs5 zAn%bycc~MU6vznyy3P1a5bbKUX!FC7ZY}^2eVgU)9~%OBluCbqLg24q@9E!Xn*!}P zDX(P$gZN07;gEHg$Fu;i$h*IL_!U<(RiYwVLP_j1RGyyZlD9}f;#`U+GaxyL*VFe2)u?|~pImFIb8u&0^n-pl1#X?>4oNuM8uMx$ibM3YwZ=A` zjGezuJ8PZSD8HxWE-^Ls3OWB>|G<)#twr;q_)9hg_slFYnK$_r5O*%9sriiFlXaF> zNz@min|-~SvJ^90-++cy=DYc`4YL}L3m&c{=r#%8Zg2%cE z(|lMtETeiX1SE*4ACQ^hF32R1{Q{ze~a| zdMA&7j#dn+H=-Y7UQWw7TML&V){TwI3|6YG)7I%rH%o%bbxH6QT_Z-qp2U4B$;5go zkh!Je>kWbgFK^aR)|?5_F*@WrhEXB)<0!mEdzSQDwSoxO^O^(#wnn3K$+z~|wL~P~ z89DHig9E|BH6zE39FMa`E*>pcIQn5-rlh-NUc{a2zG=SiA$qg$qd3>X=CgN&hmbY< z)S~=L7h}l)ynBXQvqRSUO%u#9nb+RlDRa!= zZN*O1VOvYrSw1q8#qfD=PV26mrr`m2+$ZK*ZJ4TWe0UKd1q<4IZn|87xSe2~6!g22 z|H2p%<1v;@0PPS+?LgaRtD>u!%qWW(KY|5!4Z!X8zgvY&+dr=67oEGmM)#p4?27Fo z2OudFQgMaEUOKY(c&d7CQNi*IKSgIe>o&i!hZXoIz`iNJXzENm5k!f~4K7c5sq0%0@S_u&w9f5M z+$K!~fYly}^YKRp6lA7Httgm;0WHs#JxL5+?cQ7Io^Z#wx*;LwuN26pyDUUS$kF6#ePGT4w1Cp%u4;CLzLPeSbufQxR!dd;$rr%LFcAISS9jN^|Xv{r2$#eCMxv}YMKCeZ=7LS+)i2r$} z@n^D$YjHMM&DG*-1@0*{H#_hjlfDoOzPEtbSIM^z_()apHCQ5&M+wv9$_y(gz(!{U zZ8wUA!I$NP0n4-+PPnI)+XLLJqmm;)+-7sN`~E~<);`c&wTJsxDd;w&u~AQ{i?$E` z>bD~z%FXtAYM2-&NgMoqj(xAB2RY4N%hZl!hsw$nxUeDF0yceKe?oaT-h5DT;8~g% z$f%Gx;F)TMhS=^KT_3cxyj)zHFbXb%$@g*>)#OnTF1^;eKTLnwesw->%q@X8BrDF4 z&h*Hlt*!A5^|)-`7qgMM!w7yT8AqcrU`(*bP)so2e)Udc!mm1tArjxWIrqSRYw?X zB>E2VYpC2jnf>Iih(_}A3)u&u+Q!~|+(?T73XN1wrLUhh!F;d4Jd3z|KT=R+{u+pjUrmfN?1NFmx*5I#J~(+07&slQbBr$?8hE&)pq9_l&Kk7I=0~Q>L}c7siOx^ zF?m4ZR&zQ23kmFC1#J6So23)tkAcBIkaBzZnS#g477PHsI_)23_C(-p2<%V`FlEO>m!!kM{dg!z3>?XU}na>8h7mh3Jqky^TdhS@q0H%-?cRnZd!sf^v%JAR|O2@HD+r}&b3>1abR21e1?2(mD>G@;4~+Y zp3E7c^vA;t^aqtXS@uMt&jU<38J$1MO7PXQr2z(;1hq~xCPa4UgrL_Td5(8k23gA`}XxNPF3k;X($FhbL$CSU2#0gBp7LY7~#gQv75^S1>tf zCR~Fu2skC9dID6+iMy~f=~LCj9kT+K-V8)zz$-fyGlO1*X$j7ba+3039}4F5T7wmC zCs0~N;|);HsIluGr^bXD%|TZ zFs9<<)P%XiVGt|ffXOUiuc*W8tbs!L4$HMD(cuG|i?y&YRZ>0532ict7lrpuJXeft z$eOaov;~(-_~Z-xk{@FRRc%O*m<;SmLp~`Vhaq&xWKK{PuJE57PL9)E>Mq@l;4L z36mO_zBnUgPtwcP74Nx@Xh!=JG94v$)s^bPeE}>a28FY#wZ-scAqSap3(@7hm?y<> z@YI<~ntLd!x@s3vY|+2bKv#%TAPsG(ZNywA;Zc2Y&olt#Ginc&av2(f*FC}l+N)oU zKy&(K3#r;kkckXIJ>TXere{=7A2TGnLT2kd<-TNY-S;R>)omS6A>(t_oGE7N zmjRG?7Uz`iYaua_cnU90Ch|94fO}N+u`XgiHR~z!6-GBfzzOE50~?-Q=r^Q()d_c^ z-zPsq>L!5O#7N@6RFj*Hy21DZzBWZZo$}5SpE+2Tz0TGju>Chdf8`Aw`%!`houz5k zU*Dv~4E$_;R~&f393ebWzXF|dJ&}O8-Kzqb5BcbFd%kwLv-vVgcq}FpE6SGmps9Z? zaUr4XN_hoc*rqu{~`>}s1qq3$V{VVf$PGb)^MrQPn zk-**bmQvw4_4NdncKUvByEBaC*cRrGom~#1vnY8o9LH@; zv9}6!e_xw!gBU9+TPPJCfZxzMX_an*sL~w`+s$0-b0D83AAe0v&Lir(q&O`X24f5} zIb>QIYB0YSU0p|GM_UZH_9KvcfQWpJLqT+7H%ogOvpDH(=R(braM%zvNY%e545Jf)D3$WlJ(=NXl{*AMf_%^g0I z2nb5~;MCOYp`X*uOK$9?++h2j_2ur@2yp>=;!eo4gSX_Z5%kk93$oS&S)G-m^UN$M zizbY@k+dGqM~_Vc!k=$1BhhD90GX@}*%ZyT%Sg@EIS111mrPFl5p;!hnG+;T(9Q`0{sD70lM@|}ir9^0T>*$Lh<(8liUi4{&zJRcesEIUF z9D;!1%rDgyzx2@+IfsNm!4xLnOH#eLqy0?)9ZzYRj_3<%2~1X~|%qqJQrC3Qc>7gbxJn4`2fi zv}mNQQ#(Ezh}{~oFM<@r9{IbGQng{RQPy>W+vGA~Tat6sCz8IO1JQw92^|4Q;cKD=04qY0urUcn==vU6?A z2=r}uOc>tPCF9OfljJBsZU!O*Sye8DHB9N^9ttj0j2x@J?{apnX;e$g-oam+rg<tbUb+ELQ8NbdTNnsW$C zOo$5k5WEq|3<^q5q)#T83kvYr(M8fXQOIcPrIw$8@q|su`2(4!Tx=#zs9a?(&SgD= ziJ;OyWj&dJgu&Oml*f`+-cMIyQn$pP^sTYhc|gaSRa=j9{OwkO#$Mh@h`Q$A^)^-W z#AZ_4d@03$Fg#cP1^m#Am8Xv5eK{6{@LqRu`b(a$da_pFUZNl^8dZK}tJLW&id*VcpUmCEm-_eM>RD0nF2vhuC(C;+ z`fDP!mZve45t`}9*&h7J{xit7?*6j5eHY&KG;geNql%%=qSSgj zQh#CRWR-s5*W!~D7IJWKa-cuLpEw4jTg5I3fP9osALC7TaZd2}uWJ^0>?<*OymapP z{K->jM3qt~gLt=W-)G%Z6)ly0Eb40SEXj)oFW-+{OKrgCXYqscz<+5V{@kaHfHPkx zmE(e$WS1urYw^Hp90~s{5f5e2`lb1nbQ`UdcZ-SO&RQP+7}k?AOe2Ump?0)DiljNT z629Cex!v{e-u(R;k}X2&s)PUh!RF+ZXC#uW-~$m4G4AQ!CPg29&8*c#x&^=|4I z2Z_v0q&xB*4fxQ{P0Y*|Ze5%sId8?SH`xJY6m8|Rk@ME?KraJNHYe@GGFow6AB0?3 zRMLplWWq>%^=9p9-tjFsf2?9rq#j~M_04BN-_B5`XiF6%3k`IR^}dFm^wF+@1H|`kP1Z=MJ9N`P$y77BKL0B zL_?GaGFEK$ZGhd=k8?@+a$WGGQIlnV;ZS2 z_qf#QkVMz*AC&Cz(H4``-8*4&(h{0n@-@5IR#?s=Td}EiVFH)Mk(N|`pYC)>!ae*U z2$>l1sJ%*&?2_}yL#occ%it58>i-tArp&UAz0PpFJn1T^CK{43N|edIJIwlH0?q88A1u!Zw2Wpr(<;pc(Ivl|#17iHl{^I>21|fp zcjNI{ceM5672PjJM;r20nsG{gWNK9O{L-5mDCk^Md##YEU3O>$la%au0{jkh%stXW!KeT-&1y^_0oJ4 zQReHg&EM0`E*Cxl{v-PxjD=M48gGD%#?T%&2)yo`HN6#9%{?ok-=yb_m#b!%if0hz zSPk5}?Dm_CB?lX{k&qcjwS{XP0hoiHKi>hm*_|V-ABAwD*!q6ZkCDPs9 zU4qh53P?&wcXy|B3(`mp-7ql2ci!)2uFl2$&e`$o^{oHeOFC$)wEzQlkX_3DvnWhH zo@#@pe1FqL*+hj)JrjGfHC-iDY4aX~7T3)6A$)uLh0_UhQdxTLISDr4-`?CvUicmC zvi-^7HKgRPT9{s?ZMrIt_c34*bc3U&kEX8boyHOuw8bi>`qoU!G!ovBa)Z9FEcEXS zZt+UpYCpa)$%l2{1nj(OEJJgn7Qn_WAUqC^N zJYi?Un+7J`l_#MYK#4Qd>-n?#q6mBjXdzdJzPH*s-E6pnMk79_fO#*v<)`e0$QBVq zddBAQLu+b0f;jKA~S-i)!F`i7KyzdSgHoOG%U*$+1yG#RPm zE_=&j&tSS%&xqsYOtx0&@^&ns<+dxQT>C(t@e&OTgkKa;=dFJnIqmdZ*0oDbzhO1g zcQ2WCArzUVzm%1e8?u)T1FM!dpz@olT7+tHa@pGFInjf5 zbaDnfSZT4mZQpfh!0Wv`4}54P7;Za}K=qB$|9%;ZmPOm-#XzZPpQN^#IV&s0`ow4N z!JQ(Zw#C=~CmTI&u#b#)PBsyWJ`<=GP=YTcHFR?U3YivzWNd+Y&Tr#D*!VLvXzWl& z_+|x%UXn@qZy=%HLAEb`3;`+7($zNVqmF@krRA_)4jm7Tpq5U%s#jLa&pr-%+?mMX zqR9nL<>8+;UzzApr6U6pX55{jh2Fd`gwgt+R`TnHBBU(1tNeQGwPH|+ ztg$3~CNcI}USQ_Mp>O!7?_Egrc#^JaIfqT&v2umSjHFOXBox zP}$Z-$*?e-&|XbJ%oG>5YvZlIpxyH4@LTV(Yv$8=6JxsJFI)W;-1HdhATtrU+=0ML zN#ks$<^iUwkBsQixPP|9=9wJZ_XtX+o`y%}dR;Bv9M41$SC@f3-|8KeLqI!>7`(q6 zy)(qFb2pg25-1~8ZsXa}jV@LRe_yJBAR^EvVD}(ahifpz%IOAd)`~Ea)GIP3M82b& z(-oEgW1t|u4@Jg7e5I_*sXL=gRqqHv`U8Ixtr7%yl&gg!O{~Q2NR^PSI495v+{+|E zhf0e37y(1fXr@Ghm57|~$p$#9j=qV>=6TqwMkRVbS+d^T?_bqZn2-=qjdna#NZm;~ zHL&$AZ9QehCpF*Zr1?e&Ku9pSo-UeLRkDvD`x5N7vvM!UM@ zq}BdVmN!l+-5A9cihb34x7tmh!~AY8RrH6>m8_vnK579ikw1c%6n7(aqa+x++q&;n49xwkYjlbf}ii-!wy-o&p6?795`@Vwy}^*=HpzmfsjN zRP*|r5&x7s0qVS+Xpq2p2K;a<+AkG957gy^-C<*m?LW6A@iE^EJe%k&rt913)n$J5CXVy=6 zbYb+iKby=3h6xqiea?-f`=pLN`6aiMKfC1?LCC(4T&P+z%+fN#(9q{FX`zYHp~iFa zqlTs$)r3GP>=!H_;r{&8oUiUNTU>l?bw^EjtjwGaBycX}ytut-pP+O-V z6In<=6Y|HUdu7sQ;@S%jBw!DRHJn)3ehgX^Jn)Pk`LkNz_4e%S>O{Zeh&dQ`49l1G z_!pfkLg(nXdfX@Kf2I61st5_acKw}@;2F_G@*DdDzGrgVk91-}3@ryN9s~KQ|0ulD zijmd1(@q;Q1hC+XkI5Q}dm|Ske=H^4m*QBN2<*biNd=sbw7E6=iLYl+7Eg}l??YH9 zoMrr2%_8M~1EVHpov*&tcDr-v)B%2Ry<*xp)P}qG3_vBx-eQfs$@v6*EJOKaISr-3 zLcbC$|5LLvLmRp#y5kGNr1qIWCQ8AenA-*b2gut*oMKx4z$f&bE~_cjrRv!iJFBq@ zpvnTed+)~ymAonRH$E-vf6`6c?8H;DB8n-#UNeUBt`tzo>sAwzG<~>yk*ZWAJ;N8B>&D8x|LO% z{FUcyp$;43JV<=lGr~;qllwH3Zf5-ig^^7NjUOGz-u@$bfLoKb29y0E29V#>2c%Q^ zlBT<3g`uTkfXEaEp8D^sqnA6464zXLW21(F4xAHImpA5!bJ?;c`E|)-$&Ml0D~E+D zw2vxAYe9!0r(Nj|h(8h1r@M1~O$%KTvY8TNn>_HIAl-o&MkeWalf!uiTK3Mpn^V+) zKSF61+{B!GU~juaP2ar0p*L%Fmi6_Y z)D_!}k9>a3CnMJy8hV}w=)J<-&wE&))757B;}&ITpE?+lTMPx+hy$D%=T|eD^CV*H zY$=Y5f6rQQkcG%WePQ{)2ZDi2-8?mSc7a0AxMtnSp0{~HE*M2gC-;jq?ttYU)jX@t z*$9B(09#3DM)Xk#l5^1CZ?FH3+`C3XF98tS?&r}H6Z%3`xm3}rEBc#sEfKjvTNdfm z;Gj@DtT$73M8n1noN-yaxmjP~vTvxmLsP3<7Rg%5t3l11@*e9R3wjhwXf7DBe%GtB zfMnh>w~x;Vi~rJX<=Mb1TG#sDKca^9rF04g`2dMg`*4Vcbxxo(Qw4c$mWHIz#^XUg zo5dogIo_u3%|?+6Q$Fr|oFI#o%6E=C2=wUjp@G+l18ThP@ZT}(0_}RrQ4Vtz5cFdf zgh{2o6<^LnUq~dWqOI7mG6mKsV2DH_o4NknI{iN(oZKrkrj9d7ZdIwAKScZ=)KXn}1Pux%5pt#1gNni#}aB z-B2*g-+r-hw{+c;?dn4d4iOL2DK-;=|7VJ6URK3<)zt&d@AOO@<$2rLd%lcT>z|1P zu$)I5QRx@3ixnI|z-u3%VQ}_pq|dHxG_i>LGI30ixIpj6)0IQt5%HJ7okK12mGf)du*N8Z zH9#d~f^5=&= zb4%`=ZdKCZ0q@7@pRHh>U1BZX8 zEE_sIlY7iFeUqeVzE;$=MwfF!SyG%(mdnp?z(`R8o;eLci`K8l5wr5gL$A= zKXtm^hZZn^H*{fSEa}G<^ZX=%FheNv+v9G}0q*UgN)_R`+WZ*^&a2N3F>k+r@_w8N zIYOqceg*gJ>ccCODsz$d0*M@;;dBzsGqP1y(;V9x_9I)0m`?Usnj@8tVK_UvGXT2P zUPQy#0iYg{E%Jhns^FslOeQE^+eIN_@m0$S@|K&*}=||j|_$evklK_+feSk_2p<>xxl2a4vNN`Z4;uP@1y0ONZvW^ z0iCmsX1aQbi;F~7bMGkl&xRg=x1lxJEk+eeFEAuZ_5hdqOWirrW?BBG;BBwClp7@5 zvscwyp3yf%P)CC^tqRcjbny)T(6X4>y9*C{<_8r3=@&xqkAf;_^O5Ji1Gjm{Rj~MJ z7o8S%F?6MZf@bk_mV=}Rvi9j#0 zkN-Ze;{x_S{a!QR6)2e;bs$$b0 zC$KXT8qOI0+%p&M2JTgg>KB0GSMXNM5odPM{l#J+(vxES`My!4tfFh>Ci(GZ9#B0~ zb2bh7U$?Y`tlGchIc*TR3;o#xwd~r)tB~4Wb9b*OSMG7ouzq`vq2t|TI0bAzQk2Im zBON^?<+faLx^i($nAWW)Bw{dOoTZSBM}FYM?5hMARkfF=>*=onK=J)|YjjKLZtpWG zYG+sv+2HzdGg%d8UCnB*!bfhSOxyQiUE6`cWGxjxc~1VaUSOR3wN(37T~~J$Ol%|Q ztk~4R7&n(&p#?OtcdzKp`#Yb?fvu}l3bIDveS9Rbuw(LPX`^h6R*R~_HMpdw%RR)I zQ>5ftv{+lcBwKyHe|p{cfeGw_bUc)Xp$f)q=iV?XaKiJ5?dVC-a5ZslqQ# zT<-$y&$~h{*=NI`m)~fBOS-&T+*i&xwyk55?_Xzmsiy*xSd0`%sWi7$!hKmM1*jVl zIofNEYMz1dHbw1n>MJM4{zI&Uy<8pCpX%VQ(rEa7(=cFRct|aO6!uLSYTACX;C2dB z{=d%LET$RZVGh;hQ_{wipTF8z>ECQh(1Z$n@kCoggOk^@rYo%(DM$RAb|J5PQJl(~ zDfZCRrj-?R{hXH~ zYeSTVNj#P4v(w`d?(#~(j%JFqE+l%gd`vFX|( z)n4I6+DB%mB}RaZZycQ2Wo-ZPm44uH)E6mQK=`E3b$7K7GZ`2H@qB!$lL-CQD(D=` zeOq*thi&KfpvILo`?1_h{(9x`zS@^}x$!)XZ|yq`1L*q9F9*L1{tQUV~)wSgHhkFgXQGukL+QnK#R}oerj0IEv(F}wILM!*+ z?S?FhmWG`>kGn;c?UiZQ%>!YZM{44O6bHUna`Fp;jm6BLakwBzBCCyuU5nNwJGX44 zy(-KJb^vJmJs}81LJp;%U_^j$1n&s{Hs7Ut6t?6Go zmy7YuFcdNm(GR(!mEE79e5M&Wd7WDEy(j6w7R9&(T$+#WCw6TWJfN8rIM@cejzMj4`mlpLi*wv!{?N&acsBOG_3 z3jNhqmdI<(!E7$0nZbOyfdu@cXfOGvB*$ws(0fKtIP%Yw8~;p4HI?V^K@Gc0Se>Y* z5}g<^MWf)m>ct$8+_HR7;bLx550CD3bv|n}sIgfREHjG&4)VG74k&fz&XEY9bW8b4 zfgyvwP=rSOjg;9~_`!P#gz`hlXRE{`2^L{?Trs3M7#4YblZ0LNMN5{`)nb0=J~$3n ze~D*whR~EyXiBu0=kOgIvIo5_~e9RyM>K4lmU_+W0+ey#OER4hP+ z+^``gradM_UiGmi73Y5cw;ULR=;orN@LNVDzYcF9L6V*B-y#&x%hB~VOs_62>3)~t_-gUT>x|s_-Dx;Ap9+ae0)gGoIYr;9 z0giLr-))b`$Lm$HdhBicyiHa0(bxKzZ`J5kIfNMeFg9JAZGp5gpo1NLX~yLToK-Zk zv{d-W0x~I;u#|<1w(pscyHS8+F^qALh0@3pNNrEyqi zKa2u_kAD_KTHLxbLy3B&z3RKUiOlL|jp+3?)q4zXHY&f;x3Le#r)YNyz)~P@C#$4I z&J6$tv8+O|#wGNU0QDyqP2x7iY_+n+P?lB(0wbdHM!l!jdy&G)z8|!ziiR6{_nYVE zJ*L{hVH~n8Zz2$E_(M(|FV{o^Z)RKT>AP~RD7wfNzksuC`gd46i^$f^V&_(+eh6gh z15&5;51Xm)#*AT$dzO;oIBaIdQEOYoJX(ydXom%{{eO1ShT?d$10^wH-kc(VMV~$Z zXfaa+?&t(-ze1p~oZ+2nc|E_yTEb<)$_K%xI|O5+Nua4bt(-PLton?cM9OAT>g3uw znwfz8;2)Q@m@;~_Xq?U5JMVp~RE@M6t;INpJ;>@Fj%q7gtfq^uU>`#*J*V4Mf)-5q7Zp<$BeLi8u!taS|KzdT~4~3TXu7v z;kFW`3N7ym5U3im`p%`e%5H{XvB(-0QD|qayHw+U`uVpO{|H=*H^Q*-W1qB z+37AG++on=U0}!z;EnWwS1U|olFQ6gwaPw5!mHE+Jnz($VrQcR1J_pTxr6#ZBz3>E zhw67EftZ_4z%dh5XX(Z+!*56HA#GtcL@dEr8ovUF9H`DAM{2dkVl`fu-1!0J*`ZzY z!Kt4)Z*gfE`w2t&*3}sA#s;-;l3RZ;eyDLVO^3_d?Rr2-ge9yl*hb9WnJXbvE05tV zH0l&uiGT3~1cU(i`VjkF(1Th_-T=rpRpaRy`x82*NH~E^@+izA+=;EYjDE?l{{DQm z+ON#z6G}o*7{YsBrAC&_!}3-ty?+V<%Bt`pj1G<(94e_>3g_~96y(P zMzJ#QXf@>wCey13JxA(*togrq0+gen{(10Wm{KuU{taTSDgi-UM;PENY1l_3ZhnUKo8GO4Xmd|a0X4h%}gynaAr#Zrv+Ir^Yn;Xs#@T-3U(&$D=x4b#9_2B9ZjH|M{P$P9Xa3_{zE9<%|X2$cUF@@`ggD--{7J_+yU zn}f~VM5%^z#2MQX03h;0lLEjXq>UZc1%S+daS?(BH|W^CpBzr@3KjnNm^AIm^2R!E zPOa&~4-cdmDf>Y0+flFc!p4>U?)F>tmr3B*da%9>#{3A#6lwF*YWHw&mD>+I>OP@~ z;Mq1QzSujRfYYmNTyj7Y-DQomEiOz1{v~{YaQU>SO8gnT;osCQOKY*lYMTd;vkL3P zk6K}XdrVF|XTuOQX9Iz1w$uA}=p}KWpf2p@go;uHJ7JXh!|r5!L1-CD?hjvH_WyDA zbo)H4`@0t&ntLAu{>>0W+Y6!d#PI9)QmJ9}|2o-eK4o|YhdH-R+ap~bL^c~v_6Yu^ zfua69>UTc;jJI* z98xNJl^_)IEW7!fjOR=&A2QAvFt65L|4BkI*HKd`?bq-91h{_gI8^NJZsvHqALZ<% zc3I`7&Wns0_(i=-MHh%sY;Iw>e!NM|lf0cghaIKb!gWFc!(>h*_J2Ax`*|nddDqlq zK9KL3U=u%_^IocORc~4Od!ZR;*Vn-K4$`SfThojLsg9z}&C?qAzu()Yr#G8FtZnO` zKX^xFO98>`J^`*bE4)837x`n%zC9p8+S!fi!}wRR0XGrUydj$j2A`Eg^uL%|WO(T~ zyO5Ra0U{wi&obJ9V@2WN+a!_}OvwAUNDKIAOSjMF^&TNf!*;SK^=zU-RP#XmSK$0? zlx46B!4E(iu6YHGgDvJwiuoSo=slb$xF2r-IYl(1;x$^67QsGrH8kZw7KNzrdrqxC zX+9Z^iP9WPwj+Og0ALo5z>o*zUlMxn{u?ut>I^w4xq1bTCLl$4Ppr-$qG?QWD%PTv zo+wxvyyX38SDIIFDzso8PtjuGR}C0tCEBn8F2-aV4kBSx#-0rii-mVh&9o_8w#2nMfI6(Qtl%_7!}9w|8@%U!~;|4RYD%@ zSpx^P#jCvp-Ig@mNB{_q(~1N@uBWg_sQpQtiv-~SvwpbepGZJC`}{r+SoCreq<~q{ z0#fya&j8qKYJ4*UlaXvPM}-&*{}+UA@vB1#7mWkkD_y}Cm(pBS0;!KwzML*2&?6w7 z;PF8l=%oP`Z>f(jpW&;3<+>3<*_bsdTt3Bya;@-fuI3Bm2*p8aL1THZu#rF$2#sFY z`G9=@x$66WL?MmAF$ZXUyCdqjC!4H>u%%dxvDD>frfA8hA9l+}U|9P~b5l_dz_wnW z5Bm}DnA84d3?wLLDGq!IX@pJ7+>T;V!~E#zk{BI^>as!#4|@QYdPdeGJ_2~b{~&uj zqfX2A@^zdzY!MHb`XyD?k^c{5Lnv`!T}6l(>QcEpR+fNA0P4JMVyU5a%aYM6#3`~3 zTbZhC;4E}K(jL*Gb}#9K<3&s=bg+#F#DwP<+P^_w28HaG#1)QQ-FjEn#Ch7ElAY(F z<XUm}*E3EsU{{W{8USEO%)alD*DRd`YBlxP} z{64q9-`KD*_AplDpk05-UEOk2SKKD>FrpGzF8?M8FYOI@Kh`Rhuu<4pm)|bj;bk_3 zp4wgkO_u=363}r7M67{yo{L0rIP7`EiT{hQEH2zMeZ?vZ^D50l&AxWT*I0@#{8j(g z&iEqV<>jehbVhzIP{IQ zHdwtdRpKR8UeAp6EK`R>3(;TOIjGzs=xpbdvQw}E_SA4`w=$97SS+F;_jb8k#kljH z7U1#$$XC%&x%Ku#aO0a*0{1EFsTj}d?6>+;dFqSk^4HBX_;+e`LR6{0%9C5qLtf^k zjImKgf_q^dga7pD&0+UUsW)%)P#NL=QecUG9%=;q>$d=`L z2RYihisbroSz*7>0iJmL5u=idtmW4lDG`vR23$*^3B!TlIhKFTUoVD-T~Ec#H?r9l zHMH(NZ#%%N#&zhlHkOstltGob^Z%TOui^oJkk8&234k(>k?doN@st`z;X4n#e_7#Pjd z?8#z{Pgm~E)7+83C>*5%=5J`Qe*KEk$A=Q53Xr8)@&v%Y2^%OzELBU`*2h@#8mEJ~ z;8B}c8j{zsF6XWHit-;YSSH^TK|$2CQ6iZc^8Kkc%?z2#>C2N{24q0!!YR(iuK+pN ztj;UtUo6%0h)#{$c#H`ymq26^*2l<*R`7o z2fE_M4U*aJ?fgfII$1`LOlh3ZypfW%;I!PYq3gY=0)48A z>GqHcQdbzq`_Nn4B+OnVu~=!wzGXRN1p{YrtrCB!p)XuObUdzOf7>(NpdGWd^SYd) zN4tnY4F8BZyTKuib{`zy2MLJ6PnLUg%+?_(PLcWWK=>2~1=R%oDy}yj|D$12Gm;WC zGh28y!LPMk-^^U1aeN?2)_s`(8N@ifeNRk?*xcM&XMQkU(y={d2D6z(*d8^ILq`IF zRnVfD=@>5pP(MuNEkVaPdd41id9!=GDkWa7t%r=u=4{w=L4KMgJBy;x{IMvX6toLV zUu*eJJZf&VHDm|x(sBW`vIm@;Q8uDLjTrGfo6Oy8fQB{;ip15C+??)h;xCU8U9t5P zmsS5P6u!)OjKjSn-|5ib{qECz3XeAJ^~$988W6@i$r9@I7Tz1@gjR+3b9Gw$ey%vo zZ~+a!lxqzZhsG(akbfQ5Ywe^dvQChtcyq(>o!U}q!VhRjLURK_^Uun{(gTGEocrx{> z$!#?-sN>DDE1@u76qdc)_e|dlV_-7SiX!co#`2DuYz_+9B_Z1KS4gx2$b*@p7sg3< z0+EubKycw~yg(s=8~(wwI~I_qI1W7ZXgovA+E*YM2HwgJsNv+xRw$&P40<6*Hc89* zp)!0tnurKC0Wf<^%3fE4%lypR&AFW?Z4_JtId5aHA={GR5M~{Xo@o9v@4wQ=NTpKj zVs^(Y#Dte+XrvDxIr%3&XRUJL*&I9m!+Bss_w4b@FOsCc8~d6>9T zzEhyo7>_TfrMfW>^?tT+?#S%NYD#AYvSxK1UgNLrx@KnouW~qs`pG6Wydf)O7_+)u z0=YaIt0v_TzC8bfF2{;e7IWL!Qb;Ti+&F51ZZfXxBEJqPFbI(8kFDLq>$PtnYG^AY zPBuv?bD(=#cH@=DJa+{#dOM};Y1e%Y_D;a0wzn!rS|9*&FEm>`-jX4Oc{+x@Bk~&= z41K>>A52g8QF{_4&x&J}5R+SdVB6sICtZ>Qo%6bUEShCG9xYB5hMG@v+mDKHN*t}{ zb^=9%4MN|ERV+n@UbVz@tQ$5{HW`^4`==+%6atr)^nw<8<>%S;3M5F`5<}-B(#KNoD2l zsgaxn^)P;Fj7(H2H7Hh*Yw*WL{?u!cJtX3Kp*x9y9he&%N53o2U}BKryfO>bXg!NW zRHAJ#tHY*)wI>oZh7~`6<4~*!g{722k~pu*XV1|XoL?8FQsTQN+f2SvVOuRGTnH~9 zR9>MHK#{cQp!h&)oBzeZg*dJ*_%o_%a!5)imkeCKIbs=&e5jReRqdG9ykAMyEWQ{q z1Em36G3GU%!No_!Tw)ZTTG67E)m))xU@5^yC)Xefj`M6tNjtQxJNk+2*L)xfDx&M? znyep0obRDM5hC~CQ{W=@{A+5J35o$&TdXE8z=px6>=dOE{5K3VGHftd7=HQf+wYyu z>N^WYE8KrY3`t3~!(}TX-m?hCy&{DM3|gNkKgeH}&Mu+h^E;vo2o6A*kGt4P21 zlZ2o75R{1It(=6KT7ARlZY)+2d_i@sMCDNpC#sY=h=Slr^l&CIBT5*_N1+FJt2|W{ z^yF69l+|qUxdX^-U(FE1zt-W6LsWE(eM~hcy8TU zhL>aM{3eRL?fH28-R!j}u&Xg=tBX=zKKlccvq{ja1Mz1y(G^;%a(Q4QXGYRn1B@T3 z+I%e;epK{?2ziKf^q+nW5$ravs2fXpgUEV!OwbRmPg>pCPqIkLU+>e~+tA0n9r$1r z>d-vW>fB5Q(Fxsxa-rV>xfNuhDgtEr41$yinzU*#1cUZ!A*xv)yAC=D-!KGrkR|Mu z$S?0w-2sh1Blq0BFf6Zw!JXWd>Y=zxkNl)_LvcTE_9>P;$jt^ONHvAS#_QCOMNEbs zZPLIUI!WGAag|&_(K*q#_)L`_5Haof5wE~O6-Y#YAs^cSm+`d3xXVn*1Xp)`YAd>* z$E|G`V9Bl3F7cAI)r`J(+RMxm;~g(b8`__7cyi`lI}-k7FU zod%(MO-c`rRdLm!?@qPF`j%G16~y~4%x<7hUM(%2p&^Hyd(bVPokpw_>-RZn7n%;= zXygSd3BK0*{vETKD>P=nIzu+$Q;xb3bc&I7BJ~PV61=BL}M&@iSz$^T{DEM@EJZGn^IO34)|^dYH#^#&r469#oqd?0J-V zQD2nG^=2&DQ!{T*_!IL}JrrjdA%iM462f>?Vz7pB+pu`@S5GI_^}~Y>o8e}S{mm`zdzUzBu-G968n&7uJ_y37fJ;oY2bJ`_0 z)g5b3n|bS=c)39y9(QXo6D->vo4NY)bs0)%@3LlxN$<&p?F_Gv4!FC@jJp@UG3mR3 zqRqz-SaPZn@tqMa`_mRp5EkbUy^`H4vO}x5Xu20r#u=2;6;p=Z9^i?FV%M97f_~C+ z4efdIeGhB3y9_dZ3v__bV$n=q7so+SF+YS^KURUVyz=mi%*ybQ5B@Cxw=M7wU)P1$ zh(XasO=Yl0nT#1jXq4ev>S4&g11sl4Z8LE}zeE#sovV5%?#B`gfky!wjx`jfR-?2; zzsrr1zC7&@05$lGv{l7mWuUhFWEsb>s?JUTP~USq=v?FB#T^bvwN3W-8(CE~j_i1A z`$cz`u=Mb!aYD}ORC`2;OF4mo;QL3k*BAf2tajz)CBh=aqd<$;b$3MoB_tOTzG$kc zvGG?`F8=k+)QmDGySZ;_Vb=giBWzA3zX1zgM@u&0|TXVd@o z6p+8WUjCS;C+q~l1H!v)^iV$7l$Gv}I{n>|AD#rFy?<0DIN^+`yaSHE@Xm}uHh{2sV@{fzRC_0%sPlpiH=a5Awb?zwj#+|wQq zEcRUQt7i~HXp!Qzu}%>r^zJn{UjLnG-k4%&N@AW9ttoP^9ki>DTVX7QSyWPE+pi)o~OJbY^%HYN(the|uNOi3Z>pK zZ*KkI;_+z{zqhBNp3h)Lha))H7_dnYN_m|D0_5IGk>Mcg)a&2SJk>d01aEM*uioz? z-{OJLBdXJu-$xyud9m|R$xx-Y{n(U}U_aH1NdG~&gCyKXG`Jjwhd}%8e7v3J7&|0+ zg5C^r9A^z*x462sc-9SeJHc;zTw(?Z^ga>6hC;bx6F)(7!mI-^bkOlCb{>xomG80| zpzyOTeog4lx{ktsTwx!(AQJ;Y58TWHp_;0BsFzSA{Q1h4KE_~tdt6@BMt;vq;@2He zRmsQh8t&#o;O4UW4I<4Tve{mRKm>+;89(-rfwpVi$KRU|lLvWzLD|KZX80cYh3E#- zcAg@jDQQi&+z23%oyj~nwbnkl*!Zx;{;^UkB z3QaX*(Jh-SwMJbiv_~J89E3-1y*`pURj4Lp5~+mPzVb#MQ!j67#MCt<<(B3AX!6Bi z6;@h@R`4%_*K>O^ddpal8s1P<@#3%h{BP1hW)qVp47O--Rdnyz_ZJsBx^i{)>5b{s zh{k@Z>m+$xsqo7<>~XVk%$+YTnhlZOT25vV9VOGh09SKbw?vv9gjjlfC8(D}!iwLe zgwZF`W1?5``v@;~Y`y`pRU}Z+_o9qdtQ=8`T7zD_)n)_V#QG>Z$l87S_u}Wr0uE)o ze&P@V-F$En?SjN|No!@*UxL0JHf$z|6vaugP7OAgb^QJx8<&*X_woh zmNmmPJqXwDH{acvgK;iLv6S6+=)0gJZn(`7EZRdBKbn={H+~;J1J6pA154&5UVOzB z)1_tDyPtAp3;K{X6un%I;Z2Sb4VBg(@#OcUAx+{h%T8XzldsH>?PA2DWmrKZv!8g4 z`Hc0t@>Ow?3%E@0&I+nm<=K;BE@nDZyn%1}=py-e#{p+K4le3>5Z?VqZAW^ul~)>v zZiP>~%KfdKc z!1LV4E@6|r2-7zyZW9Go4(?5I{I}N}yk?xtF-2@Af773*&i{qJocDZ7L@$fWK%@mv zhOB1CBE#Nlwus*!v38^J&{HP;P=rK~7yL1B#P+itE!r@iYR6U@ddM;tf73k?`f*>1 zk)M_llmaX=^nc6VsgX?tiyen#)F#@1ZNmP@^F&)YFOw4hMD%u)yay=PDY)(}cJ=r& zE7o_AM zvFE~^n$H`VY~58X(a6msq}QeHElw(b=g*$nJ$sxcV(V1w_6a(a*t9C4A>YB_e&LZY z@}G$KdU;tS=}{AiJwp;M?LLM^E+_9?&-j_el!`C$%m`1eOC6WAH20Tu=3nIoN_sE; z+OsCca0@F4lZcXt8bcOf4E843@QWbW?n68MjmgQ;7!;NjTUrxJR+_;(ZEigjbRh2H z{hfdvH*nrUVR-}c6v{RAnm&`?=JSb!mMPKP*x>N+umRr(IS^WRx0BQ6B3V|8>4R5t zivMVciiqp;NrUl)+|r9krnP07yJ2V^p}r-(~-mzQPP?Hmr?$e^K|2~BVs_tLE!tTxC5n!89LbCKp{=ooY@Xm@3 z#-Ze;?>&)wk33YvFsyqyPsP3?3^_LpezA>TaXg{VM8OOKHL=Q-mUt9UEa383_{ONV zaH$J5iMM$_L0@>g+NKpQyR1m#^|K$Z%B~RbHRTA91;M}J?B*vBPc@#w(++ZkpZpJ2 zDR18iDB2{Kp6+Du%<*N!I{%4?uKj04Ds9C37-0FMXW-VACZ0+7i5xjeB=C=16ai7u zYh+WEcyc0r&J&RXB$_aUGRFcW`a;&Wk}~oM^@glQ*WCzrD85!=sm6lh3CMsE(Tz5_ z_I4{qT!um^JOhhmctJn(rA+%kBd0tq-F;JXwFOU{S}w9Z?TC0P?*IwyF!-Dw3u~eB zfuu09Wk%if<(9GzKY$zWtyKX!#K2_=4HQ4$K@iV{rMsnO7emh&XQ!V;4FUzekzrm1 z>`<(dghPrpsvq65T-58)67*%_@wJP{YiBpJ(EDnCih%HKh^31}>!0FPcW=7s7ff8{ zQILDxJ=TU5K_u?@laQz6c#s%gLev-h4rZ}_3DtUEp|;n)hZdH;Lr1XRH0XQyjp%Y# zNlGw`(w#eJNpLP;wKsa=J}2&ZUERV)sR^PTdrb#1ul<1R^{FY~K71vR`&A1p&eLV|7SzjDxn3 z?kXC6;R3CH{VwyOl->cqEZ$hX-WQ%2Lk9wdft2N>bq;oGo|&!?B1?fW0*WM$Fw~BfA?L2wT%7i-7F!2`gknS4Yd&(LLdxJ5*OcCBW9j(d)W32$Taqi1Z>(i_ zQ42=}T9o7@&?9(21xHB3!)L3~WFXDF6MAGGM8_}u^p41#>aHL=i(3Q`uoY9R4CNSz zOjw9q;8JQS5c82gV<_BGa7=(c_2tbhwnpT{GXix9uNg9CCouJRP#Lh6N_AvKe%^M5 z)&Ch)i1HQrxY_LI6;D6}!logZ@?t=)NyC*BPW^c9RZKsez;JSx4g!6i|1Ct1hk%n$ zXC=poEGNUGMBo-l&OnX;{t3EI%fhy^Y+S;i2NMTb1<0AjAC|2oz!5UGk?cOc53G)F z2?@rx1|i#llp6vgMqj`Ei6yAZgv6?V?0{XH=)}V9TaPrzm|Z4YNcWvGU*Q5r&se)K zE6B4pnpY;$&c|$fG&+FrodUkPXTCxy0k!ntjGaJl4109)jknrDmv({z(NO?>cUu%C z$^qCxuH-A$ByL1f?WqptXT;K=FzN-FO-b;Vo!9-9B>2QEMge$XxCEUQE9nUyU4*6J za&az)nl@RjaK9B?Dq;e_bj2^T7c^P<=$3HLC85wc(I{1cy~xI!`dqoM2SUGmq37f~ zp>(ZNQbO0olBPplF#uYeNt}oO++gHqv))|ntHr2eg^|a zkC2Wr8tD)Ogn=WzNGl~ZLQ+EMp5!PgK|%xpr5mJEIuxXlM(OV6x8J{eo;}aKySw+E z^S+<=95S}==CR*2>yKK&bbjWbmp0>kX{v-pq8|!rp40^x*X`l#Pp0v(#~fWdx*x%=OG7`KMEe@rk5SxXt@S;Cwf#Raf*I+EV~PW_#V zv_olF2k@IZ30$nkMODDp;H~qXDPi+Pqv?2Zj9Z7+YxN3hcC~B#)CWnAL?YwYwW(b< z6JIYh=bnxSbp?*4nu_6YA`kJW)tc1PSw`;Bj6MyqFz9j$6boIrX8RCa))fDOXo1B%vc4eU%2~uL4*{@_OnTz@I9&AA!dp=M;eHN@?_kq& z^;TBfeJ&J-hNo?NY6m)76AimgDZEGs1(tQ5FV$pJX>x*dP0)tgl!8N#+SoAqSxR z;9aBXlI)jZ?gFfctlRR|t>~3+651o&cBYxNqk(H*ivA%ncq499ow?5vUe;TWR&?p@ zm+b)Y6watLc~6PKA4%KD<3RtKJEu|CuG4$>WOu7v( z77~xEn_*9!spquQWQq4N(Fj6aJ=ZD7t<7w``X_7$ZhFOXF=fn!d5&2<@Rfm0 zu}8DL3$PxN>3DtF*T*0_Lnp-JV`$zd=iBWw3fEqR8-11=o}I|C4Gr_VQ4F7}FdYZ9FAa|gUMZ|Ge3fkKmN*PfE2 zw&AI@(1Pgff4Hxm`X83}eQbTdfb8=(CBBj*_}5fP8k>7JsTZ&l&Q7^%}j9V|a=&VecVA%SJcn~Fn0lTvjxDn$kLAx!Q|_0=NZ#4I z+pif3#~$$9JAXn35j9 zcl%Q0Qq%O)YdvQGwfe(ofBpAQE3^nuf90PnFUEZPU+y&=_)K*7`vu}2OpyPhnZH{ZwvU7u=l&sGzVGi3*|=BS#2 zrr~i6%0-{#h2$^ZnH#T8nXQ^OZ5&u^xmPUqax}>4H;U*+(LCX%nwbmj&-1<7{KPT9;W>iBBS`oxJe**GVVQIt|)^_;KDU^&Oi zi*BBPY2}F5{@Tb_VG9%GT9Wtcn+I{*Tc>Bdj;l{I?;@Ps>4cwFu;HlID{(YzP52)P z7-YIM!PNG!a%zVAqDwBj&fAZW$Z=Tb-In`FSpQ^O>MoAxapqm`>WN%C$tcb@hn$G- zFrBPH?!}_$B(Ypetf2bP{`|)yIVR3t3YkvLc4F*7W~o2A&rbDM$#dq1zrp@adBrb@n1aM5`t!KJv4qdw1f0#1J}f{NS2U&d zD(J5ESMR1(%bi8uhZfulh$;p{#w%jeKP`8yapq{@w>!CYM2&Wws|@Q4ebpB@kz7tQ zwx2v^i;Qv#xW5rPU%O9_-G^`CLUk3X*+svo09FQlWPpDLK}TRQUm%~TGiIj2j`kw9 z(f4brzYJ@TqrPm?sr+yAn_Vfte38Mc*IZ*t)<|;0gqc^vaNQRl%O4$GH1nCg-4lhg zSGfvyTsADvhw%jovIcymNQ0xhHf8XiwI#W;NP6Ol-~yrnNVXH$*UG`3J@}a0g#9wp z2)e#e`rlSHKt=(Dv`4Gsz4bI0yotz-z2{BsT*wnS8a@O8sLS?y+lmWDSglw1j5j$B zI&{)7#}HmNWN~H;ZvfVFxqrM>^-sR99|(HA!y@{m3z>K1Y+6RE^Yqh`@y+`OR%e#+ zlG_!Zq{o6BG0C6 zhU0yWDPsQe*Q@zBI4K6d;POfl87V|$a|K^DgJ5AWpGNGY%nta_uvx2DZ6XocvT zLdV&+Fylk3*<%aN<~e^C?mAtjFPw88=RMA0(Io;VJ!3%V=?Ue(pfg5@P4gul*&M^0 z3C1#C+(O&j+a5vTxS5BtZc=~lGJL+ZMM|PU@eQW;_CcHbqU0dUU*S(2d~kJ!;dUhN zyxTu}Z6g!TGj{aLDawyiZyUV~X3C@gPQh_F)ZU-sXK^+CntotK8|jN-&Z7mJ zgF893!3+}BPvo@otlKu{`K~?U3o-J6b2pPNU)|j5o7L^3jPU<^`_RelLI4R>qU)_{ zEE){(UnONB!$T|sU#8_*23>h_DK_p+jgPhDW3>X0pN=(WeR~${C!4Fv2W9`-lQ-Ej z$<@<^gI_V|JUokC6AdTdzirQb#kL$E?`6Vk(*4P47x9rMqk#L!g`0A^rm0j@YZ~Fcd@8t=`s)zw zI8f6(TWRig`gp&rVzK#=$FhdGOE5WVH8^oH2-%+bp77IN>^>26oW01P3 zj8oe8%i2BtehIuOaXU?E)2{>DM=7!8QWUr?VPED04=l*|UzDC`aWSNF3N^O}-K|f= z1^P>-;{MkRV0VL}=MOIOkYASu$RC`+DW0)?Voz^ue!uJXJU|u)6M5#2FYmG=Xyx@K zEmuEC%bx00nXzX%cfih6|H<}BKBEkVAdE zW>Oc1m|E?xtM6H)Z{r?P#tq?MOL6Wzq)u+)NU*U$e5EWGykdYbCzP+uz3KZw(VF8e-$auS-$ZLgfZ_ZF6cWW9=OO0nvHA0%K zKn%rLkE08SBtfZ$@&W*GhVUyLbDKg{?AI%cQZ<5nw}0IBINJIHhnP3Bx3FV6#dH9N z$l|rQ5%`_ablm_4g}Aksk5>nm%7Auq(~k%F-Vbeb)9qOb$@c*xKcvhbIT^i;U?76&B@q}0L~X3@cwy4N-LvxKf=&!DS3(h#;N zWvjY(P*Qp;QnbZCTuAj12=>TR==zjL9sS3Ai?yDh64$O%gbD}7@U%l7)-G2gWC^fa zoxceXj3TGKFs%={BLQ)!?QvCO6cjYlb!;#(BFMfk=G0IqlM^O@ky+exCZhJle0pTc zF+UIp5GI(Rp@ngxpITc9N5QI45GZ{YK}fWBj-0N;(5KIxb7z)7#i#}FEEUcLiHe9U z)yU&OZnYO}aD*A{7r?M|UwrUe1zC;8Z+dZB3i%cM{k@ zzhF$kt|)7m9=m{96BnFIuL}=zCXMWSX_`SrQQ)A|6#~H7&HyXX=v`>@=>|yriRf{x z1P4TzV#cs01s-kjK`r9}o~mhA>Q1L-=o3t2>=_}Y<0zH{3r~7st6iUI9 zqY#uf9^1O8v++u2!ePWFSOu0x&C5R4GRC7ztTM~QtlFmtCRoDA@;a0qs!FiHATi{P zt70btW-Azc?cV&r6%xkqE$H;s8ix)o#?>MkNSNMN^|U*w99<{>IW7o~d;zpk6SNm7PH zz5MmUdjEE$2|@w-bRO$(fZg5OuhgvQ&vujg=NEQWFYH}ch)HFZZ}|@W53^8aRnijF zd&SYVSjx@!w2~%jGzSGlem`64ep2ZE4OnGeYJA5wr0?x19OZ5uF_rz9>f^%t&x9{s ze)Fv|cD-6nRW0n}yQO9_c-G!^KV`X+vJKmXufrVIr`-x!%-3G#S@I$(0a*&2FZY?3 z0KE1fbpa4bhrz5G#M=1wtVwfID=C}Xo=*~TYZH0Y!>uq#t9 zsQK25bR=h=l8yuA$^()Fiy5+51pH7};xjOR{r;u1C`jMn-w^#mU0jsn3f;uiA3=|@ zRa|l6tBT%WFmhM8MEEn4H`;BeRe2r)Q2>$>NW#Pu(_dLZhI0WX{teiWP9XXd(jyT*Al4 zV2h&v-F5R|AKS$IW3CYbv}uI8XPWv9mrY>03@H`f?y=u{3BU?{tcMWB}MFW32IG)B%_jQW(^K~@1x;eDrjyY?<=E*s2C%}x-^#;#hDG}wVtf5f?$B9 zL$xn!C50R&`zluGoUu&KJfhdwE%eLHuw#n5#o+#yo8Dn=-f!nxA;93KYC|XsV0$F=kO_d#>{nQPwVFUmKG%ueiUDOsW(N)a-XsBZ+5n;Pb! zJ`1}*T=crNY!NH5-&k#a+S=aWzPj`O^tmG8)q6sL3SrTlr{WAPB35#9mTiK8)n#TL zpz_~+F@F~4?w&rEcssFO<}0Bo)5)%YOF|O70fN__M|*=fpT|zScn5Xstq(XN7U{%q z|Agc_vCg<8U&d7}z>iY`gED6kEJy;o9qdyj4E_eBRJ^T)Bj#q z*w7JcrAp3}i@0DL(V5bDS2*3B-5VRLki}!W@%}Qu8}nZTb|8A9@HBOl_)07(J=yY! zJqy{tF2d_QuRjqiRp;}zWGs0d*?M{a#mV)>U2oEPi_6jP!O_jJ5ROtMNIdly-jNhL zhCpf;BCL4yLgY>}m*9)cJS({HiHlOdMd-H+A{@0C>ilz7@1dOBp!tdQ<52^~%J!1X zjYj!D`JD^qm7{^AVood#a}2%6Z`lW&3n;JTODt+d6G3fU??f9RGPqY2d(P%beMFdj zJW_|EODH@r^iG<`4y3U>DlPJUqwnx$H_K*Y)!6;}&W$`3@b=U`Uiv4C!}sqm_g;s$ zsw*^2mRGl7!8iBQnVBE1RJ+?`*f{rv`zN_i?ksFg;P%c{PcUS?OwKm91@qrhd+oVt zPbXDM<%Px?>9R$d{1m3FQoxUUMn<|Njw4fL^{*V`E~k~sk2lW5&q?cJ& zQa{28Qv~&-)$>J}I_)^}wT|sL;^Y{foWwtV+r=+n(MFDKqm=E7W{K3Ft3F4CCqM9A zIXs;*lf*W!8oJzb?uq)3vR?!6rwNtizr^>Fv=mC7mJeCoiF)?1&G}5mwZHAbX3hDi z)MGNcfPmIhZp;foVX5C-Ju1%{-|c}!Z5Alo1e^8Nw6I?sA`8d~oV+)5xtqd5bNfGU z9e(?arz-6WO5_bQceDL8b2+mHf%34nzRO)5RE$th%x+E~%#}>Euvqe_e~NJ%7r^!{ zo&;H%((+WC=iQt0Wv#j&g+kO@%*zMY^M42}F0o#CQ?sh zVZws-a6h^)Fz0i}%rkQK0wiv{veafm(PLntoB5#ouMwK&%zh8x00u-%Vd$;HZU7>v~N?}>cwjC)tqZqu47;I4`H%rc@0IyW|C`+zvoWUMHP_2L4U(Fgz&CiZYkwe?@yuTx zUUVtx=^%+em1p8U$I?4V^!JDgyQ(H#^(;QF#gKTWA84KYd$-IEq3%uG|E{3vBpk@H ziGMSPYx_>7w{3)4i~Q`X!>v+KVEZUpG>D;{svCk{GUS3iUn4co;{CQb*jsvG48V5f zC{HL;}%cu-s-h} ziffg#Dx##?-5tJFOnhQF7s$) zm5IAwvL~nAZ?8h$Ug6r!2-{()q>;?~;z!ak;}nOgA{L=b6i?DxW6u(pD_E<{onqb_ zY#&i0!iXRtYTj^Bo3^dF8PT9Jx}ahse+OEBR0Z}_uOMkYz-!7=*+f`kESX_byUE2> z^Bvcjv7V2vcMRaG-z|!lRG~J71uh8K~NxaE-vPd7B!k!v5k@?5e&(TeoBqB z-Ep>Bi=;HjB)b89e$lNp;{x&x3rADKsMgq;2K5eCH#Y`74p+V}_Xz$HxOcWac+AMG zxD_mw!;%e)V&JISi>Tg<7~GVcE|o|#cNt^^X8$7rtgo>AXBr-YUG{XZsQ8yD_noF6 z>&9@uB@>64wdm2L1t{H;$qLaZJqz8Cm!JU!JNXjlR8EA5r6Q zXUvvfFBNzk^f_9Q#ixr!8aX&9B_G$q!a=whb^q-ngc?shUzSPHs59vBp6T}d9_=)a zoBG_C9Pux6>)PkqHfNJ8kZt#le^hqnRgO{~8TQK1ym+!audEk))bF)@^tJyW&h&D& zoBZs#+kx-a`&Mfuh8AYlMEPg|RfTBH^h%hI$#@e=m!? zrCEb=Q~meT&qN-1eykis)8rk=9-SuBS4kE$eQi5n&{)PPwwQ4r z6Z@W_I%5Z}!^#UfrOMIyOpc~n>q{}v&&|3MH%e`jl~lpjJA%VeZU1oFCsSU(?n@Js zO>2*&S{q@@)gIR*NCYSSC4)QIT>wfTzcXd?OSLCV`km~gCa5-EU6bOrh?47fHP=$3 zXsl?I5|6L?B&SQ;GIv@zL8OT4r+>hN@?e?teCnhglX>xj>88P*$M^ch*zqO*8>zuw10V#zrxBzVI|9`67mN=2#xbOvtBbM6cJdi6KeZnI=#-UKZlW2vpt zs>){?*YC)oMx|>Bsynx#LzW+8g_#4t=q$CFQUT82hCY{yVcDM9j!qYBAW`&L#}xvr zZ7N&>D5oA1DM`f_IaW&Fj6arR-z3>*c9G8&jxP9gQLtxf9s{ngl zODYNa_!D*Z^&-+iQL3>YGSleM)20&R#oupnot{s5be!SjN@C$rAM_AT8lEU_CrK=W zoee)zj*dyB*T?>ot)mYnKWwqB(jqeH$*+2Dvz4;)%&q&gNZ$tz~i0sHghH! zo4v+pef?meR{mGADbcjJw6CWGcTRECb$7wLUph#=mTcOvyS7=p+uI*S-fiWt;oApt7l@$-k81?^+$t|MeprHeJcz1@3t~7X;wU zBamz)G;QA6Ack7U*F0HXzFMupgBE$6bK%^s8iW&UPXV5llR5x8yJA$`xTN`HHKg~` z$?k_Ul_~g&g*IiQ=!$s>gcX&*sCZi$aygO!3JT;86YG{N*3w(Ax5HK^yXin(BN)IM zkgB+`d|)TLct3<|N8eEfy63A4?auqfm?~^hdJ@VY=q->)3=7Q0 z<h4r4Zm|cU3jjtbXo(cINU)|=M>*}?WWL=xoG{@Wq_Fa6Z@v_Vw zeOBu{1d6Zp5)u$v-P(#>c7?!H(`p~0^Stm!9$nsss}F|T|Gf>y(5F2(WW<&YULW@_ zOaYkY{?n+Z*QgUOtdh8li}AK0Y}9GWx}A_}Egr~P{IBF?;u9 zg?_Mi(*>ZK7W*E2)9;zd81sb(?$}QUM$stm;4qMgVlzpF-!hF&U;dV(TN(dP=ZlE0 zkR*CyFU*_?>@E%JZ4t?gF zs>RO8Cmb4PYad=GA7#Qa&6yhJ>^N2;QR>vZ2#xxQMchPsfOE2JCz}{3bR5cQv_*p3 zaea|oRB+Z<5P)Zmg@Xf^a6>oJWlW;7?2GnGZb0ygl-Ugcl-aSBu|YXZaYi8{W1nUB zA7M3SnuCmp!Vs&l{4QGRoPc_gqjLW;yB1#u&Z{)fjJEtB7I`{`2gAcx!!(>=6giN= zeGryxXS+Z69WZD@LbdD5`)&?PSFyEcT{ZOP- zD5M?k;q`VUBz34Hq(xQ01oVQfEsM!vRr|*yIKsv1JG(NWvMO`JH%%eI3#yUg)-3H= z?I4g43_~NLpvHhZoY^={g2r)OR@43_b^0SnQ`!IPB{&kA%JrCn#NGTioj@&}9Ii zoWctnvg07}hqPsX$Tvtv^IPBFRgLGqDwIgPUHi^RzLZg;{owHwf7m*NnTXDYMt`<4 zYW*AhK~4hdapQAZ7|{hfUi&=qLuX3MDH+shD0{4Qu=wD%QA_+=;H4a*sp?#=-j+cmj9MvvOm9L!h4MHr`Sj`2 z!UMTrh8Y7O#pvdHt32)JikMJh!j+3Z{H}OF^CIPE9I1C|^_2WZ@BS~F$StOZ;3PXz5KeA**vjhucoPIR^b{bx10BNnP5eHF zROG9Ly2sTxRmS7gL#g*C_go{=x1DgTp~vHT<$o>;R0Tib(81=59k7LZZCKghqB|SY6+sYDnzGPdKG4aY8eO*6>&4P2btT@9PJKla_z;9D@gYO`8{Quv*&p zfyZh8ubr3%x}%%xRmTduL<*u2Ubu}HU+5Li`C++b60DMWUH=+BNq6Ta%$2Z%fiPl& zObHuW6izC|OO&N`LgO&L(*pSeEUOsq^>L=Wff*zUMHC%9U}WX|9vq1Rv%F(^Hg4$V zKK~D7NO7Rs;m-XF z_Is*~euApfxFLS{y>Lx6D(nCC*joYMM7eGAd+=1#M58x0ymp}nAW9?x6<@049D(wv z(}cBvXt)=?ko+O|Zs!-5FHZb7DZ2JfoYQMVYV5d+y<~%%?&!JwYt3Fm;#l;HR9wOA z`Kj-Y9RF}PD$|u;kw#z@-Dg5!C=5OEzY;~dt)p5VIUE#}3jg${R7X)EpW;|K``l}>61Xs8}3w(qOD_3*EF*=EG+lQ z`lmzk@%8Pa36AZmI4E2>goB5rGG&clbfad1Z9~u}=n{M1TD`0P@0v$eFn>`j4tN*@fL{5rns~Q`!N!)`XbNp6Xk2>1kp6L3svi84r&`X*m&ct+j9vdE%`Eh>>Pos@TP!_5=tp^WN1{z^0Dn$OV=J%tNt4SJ zwK!XTJ8*D!Ez^T&i}O2QS%H7ESCyvd=>bO${LQ)Nc{nXnUCRj+_{~W<7e`dH zFpQ>a87Y1~b}#ZJk_%w?9JBxes@o<6j+|@x%+;z=Tjb)y`gp||5h8GgqgKwq5TCK8 z;)#>XG#Ru;c>540)80Ifhf8ZLTcs!+KW-dvv8Mb$Hh}P&?b>7CU~scqOgi{a9XX(@ z-fFu`WQ2%O&FVGGMbe=N=9;4Jg>6AP;op?l(Fj{XZ_MYZTY9{zu}+u9LHtxw!wW zzp;=K&=S6w`>SV0^KQF+KMwPXB{C2dAA7sB$7m)NDV zo4bX0!E~H6xjI+q%E1Mf3M_85o*}IL8VU{iouTEV4paY4TS)P&%h2>gB#NYxGz|&P5qdg8}$N&e!Y9KvouhgNJu$ zs-0H;{ToJRq6krphHKvkA9blr^>4j#tyipf1m*nv?JGHt{pmiYXtS=rX&xqUB`bv4AjdaW#WD}js5hCF#?95R%i%ChLa)ZQgf58 zW|ouwJ>QJ^)`@(AyL_s39J0R!Uhq%CpykobO$+vojf06Lw`qx+-T-u?QrSE^XQeLE zh|Y?;|N3>G*y9-$Lu9uD3&!rPKeasUU*Jsz{1Q5w29uUq)xWoD(+bs@hY#s`9T?>N zmBY4U1f4v;o4WWi%A;6G4elAwjAdAF54gHrmz{qK-1qv$-L77K^-|FpTA6WE)mBvb zfE;DB^5subE)U+p8Zi%2cy&sa&xacN486Pd9Q0bHm;+|;(s4o9BRpM`OR|nL@`FD3 zti+ta5J~}P(DbSRqZ8{`bFV;9ljueIakd0$Jntab+T^c+<@IXYbyGR3+-q8zp-L+$ zN!r8(hL5gNkZPJ31;EfGGzZ;?kHp?hp!Qj93SG!|XP-Yg>+VEq$}i0$M*A}5f0^I* z2w9vEA4iijVAZhTjfQmS%c>^zn%4!Z^Z$CFs{sL{O%g~P>ICe(xHRFou-*mpvZJgI zW45-VDEsrsj^F!Snb?F52tn1l9XXPU$H*+~=_(L}nxCRox+DZ8KYm3|Ox|K#T5J&2 z|GfIw2c9P)hF9}7*A|ZC+dAxNWay`;ye?&e5>sm4xtO5#b)@A!^9pEx zv9Kdq?~XkaccJuOZaMY@OXr_@qK4qlHn$%xm|~yZ_9myd1b%K=5~B)OeTyY=k6t}~ zJeqxr_<{YpDKIS^j*POr*`>^SG#Y62F_JRj_w|oZU>Njbv&P9WQ80D{V%A%P^{{}BkT>{)4-CsLv zrk1V;bK=Lu^q2e>-zB3^Z+^pNDNBEskwUe)O+0pmGs9^`CO{&rt>>BTi94aVRY6bmUIdEyGOcH)22N??FAoPCwMuE zT?K-dq@Ii#UuZBgtL%K)Wb*`(iUtHcdHF{yTnTOk{!5X7Qz%A%r*r)Kp!;v3 z<<$=!X;e-?PZ=!HE2B(qz392vvZagVNn0T{K;mz^SMB!jp8mM6Vf@-qGC2EzVrO5X zL;zO*7jCL8IR|+<3Zmnnz_iPYKwM{C%gM4=qS5mmLg^bAzE2d@%9Jq>-FFIaD6AnYWhcNWcSVPx`~KF6!^zj$Mp2eAK^gB zIk{+D^<4y4#(mYhBOG*v@oL6+-=C;2U7I0T=oTuYYMKK=<*axkM0#FEPyPg{cE({A zw@&1w&Kz4?e|x?==+dJyn4fMn!)lWA4ZrA{2nwHli!10{r3;M}nS^%&h)~vpJ+;}w zfPe-;^E7+;a%Yw<#zs0`tOj2tXwx@j@q++>a)?gS?NGhzd$V80wUowvxiR>Mlecht zYrOVr=ZH)7zw%6T855ksM;^}hi$PlAP$&g^a8AxcNQW*4ho|$iQY!Pcp6Gm$zmJXX z_kkm$2iIp4nb%=b0jWcjX|Hk~=LqT&h$z%RLJ`3@a5|cgcseUv(RD=m26F8Y@=O6s zxZfAadHOgA_$8e`D()g<4Z)5W&Gq>EcVox1fV84}JMa3@+7A&C%8Lo*O!Gr(=v znOjX-%zcARV>NN^h)_Tp&HQ@2uTzc0e(%!_DvMOc_aIC9lWcGmd3kcVhwdA*N9#?BRB2w@s;AD#Avo z9fWtv7-S5Rg*qM?UN@$cSMwn9@0V+?tC7*xG?DnEK`^Ccl83j*6Q0uT`3F|`WzrL` zZ}&G8ea5E9LMkC$URPOF*tm>{j#fJez`(*-`$>L^K*Vx|8Ja#0RmDc}$cf^j>&r@J z?!+7v*nhIHrE^!Ss;zyg|8MA30s~zn^K(*dHjl_gOPbgI1&!azn&(^f7g@dA^LRHf zE}%HC4}@EOs71ME-v`?a=X+m=HGG!w?yt53_s!Ivzi_y*qh_+U{pqTwFx&L-y$l*R zC6R*)3Mkh$zdMXE*%p9Ph@PRnXtA?BiZ1M*-z5L>vi>ypR2-<;RZw7LBLQ~4(h%rk z4>oE3X$>}&>Ew?sH0BBel37_R4@Cf6I$mdJ0+jR%NSuKg81WCPj^1Hm_xU9ELbEMs z^|q}tx_^j!QwBs;s|yZl}F8^r1`q0X~4W$hv{2b<`X|GEvy(igQxWn)Hp0YqPUJiM@LJg zq3VdSC_tLno$=z4(c0->!$tg`o96_K0^NrS6c0^co-cyl^;ySMQoxD)gvh$8D=^#) z&|xa4S-VB`+w+tFG~LW!2wHsKNl&Ueyp0_v+G;)B-A*}Xg#U|qbYiYd$l%itbFp;) zF(ODy4mWzh&XUzsheP~|=!96Zsy0eam4VIkeQ_QN#L5XvRTFev9wnR?lr+l7*G>tZ z9RdeipJ&T3c6%{aFFiFq6p~_c&OhAXnzhXd!LD+e>rty69w306QoT?NaR@MsMfH>c zJziG}IM@$ej*+j1kd-3#)UOhbKz;Z|@`hayHXN8JZk5~a`P|)a2p}vOF)zpvQtb~= z#16LX(ozC|70OxAx}ZyBXXdGW(VhjiQeM{ngp1UUB2DM)0(Vj%K}!_z7`S6DrbLN@ zU?uh88c`Q9M3;3m-R_rWBU)X)*{{}9|t{Z7G5)6#{&4*3RqyfENLqO83OOmemLwS1a1Nyy#uCuAUmw^gzLI;R}Kix$hhY zAaJ}i(#;zGk(_(}+2TsAm?8>Z{~bV@ATbHcuF%1!38sJnV+Wuer#VKW@KUr9t^CVHgM;$G!<33XYDD%h{P|Nur(cU&z?h(ehDh6zlL@yN*AdqUHXxYi89t4B(RP9b4 zZSoVtE@r;AsbVf^30?5(CuQ^2n@Vw&KWe3CNfc+cDy)RVIEm?^pp+CsC677rJBYh> zo?NFJb^8=a3p$S{nn<#h-(vNgNc|ZRn#!I2$I5Skg!A{Ajr{K6>PkIKZ+Sd_x7zdT$W-lT@^J};pJkWRqF-iD zBLAYSe3QC|u`iZ571l^~5NQH~4iyE)OJr7r%2bh`c z6lJR_+{i)+5fPdP%@SmU_G^CxKuoy_i88R^Yw}cLPz1aWBLb|Mru|Q*EA_a4RL_vWdMA(7V$J#Yl>nZH=F@ zOvk0V!5_*}sDfj|2ZBE=#8Fu7KVV-`OfMpWa@b;xvTY0V0+U~4Y9yjA3Bf*?aoRLY z9)Gyh(dR7&BPJb#E?@l_40*nXtR5-X;K}m@5OR4-TYWhf_ zAO1WuUIXXO{3jRyP+r{=Shph(@*xjpb-LhJh8Q>48egK^pbO-YeYNw1fPx zkjE8E5xdJ19NpT57o+V54 zA|;E63(Pxn8i?l@*|nrrV0@o<|2c+ghH{2e_5lV!py@guqs~-05gdx3NBl*<|4_43 z8(Vp)5EI~FiUqlt!yI1(KTzYhY*w+r=K!ef0eW3fTv~5Y;%m)k_rYH6GM@k(6mskB z)vc5d;sZIF2M*(+dy3r0?gcHXRlK3OmPpa5%{}l2(2f3SO>sxLAZ(wWj(=!ieeTTj>_5sFxQ-bgP~*zs#EiPW9pPcNmJVCi{`S1k z(a?BR_9ORa;fD|N6et~-&5V<W3*h#&q_8o9;3SK z81L0NWADtohnfY22YS~Ls8`+1=Pf6F>}y{l6cK!4e;Yo@^qSu{UT+!Pc1H(_wu-lT zqv-+mqdpV_;i%uoBI2-@jD9in{H%D$*yHqy3}C_mJZ|x?HG+{mw(nI}C$zy54q1%3 z7~H~Cl_AC*Nz+R;s^I&NVjzS8>T=_kbchxeDMF0`aX@Lg32G-Mc*A&%yy3d`Sd%a} zcc1Wh9XI3pRUdB<&^E~5K6<4tb|3ToouxBP4*&tzJ<|1-)>RvrCCqI;}|RJ z6xoQZo6!3u@*eZMt;epI=A@C!niRa;%3Gm?!;R3YLt5M<2Dga!<4S`}+_ z46-NbaB|_v$H2>vt8oGRlZ9W4xF5K~I<4Z;eg!^ibXB;UXyd!jxIY`8I1M>IZVDx( zf>PmTdsA}%g<3&~5w+UyXRu?C-g*R(eq=~oEU7mKMy6gBsf&L@YHk3{)1gy*D0{p~saD*2{`P!2ezv0(685cp(u(Ku(Q_%J>ZSJI)Y zxx0BFP$0{{iI68eBdqBcnGqP}>Gf9U3ZwE z^158b2tSj|Q+i|*tz5SKtmox)HG%xq=-=gtsH|pHTEVkbDOw9^LOpw4&}{cQ<~F=9 z{J>TERIB;^U)y=s8tVn35$gqXRFhPZq<=I#kR->yxL7?@k>9}{BCVN;+6oauo3@b$ z5Ttg>rr|+w?Whbnc4AqMCTv;l-tn6DIOdUsUtD+K6E!lno-cC*!8}_GxP`EBe6AHq z*>a+CgG=&g*MZ5NrzTUaHh#^Us1r#U5C9Y%UGmJjto|5!4ndClW{|Q|EsJ1NdW<_$ z(VNdb4wGy!xM)~9c0$(&rnoV$R68M*t8DGLYNfsoHUv=;3T+k?rO-M0B|YeC+N!Ua zQ%?V1NGuQ1c=Q=1zCwI4~)N#A)-N_FdNN6ad-BlK_gyF8?= zFI*e@A6S^AfG*T;#*yOegRkWc(p3KLzAb>A%w85)R?zX=ndgpXWQy4AoYVy#WLlo^!Ax;a}#E zr4-R@@$4%Tn2d~{2iVnBmtJ>i9;a+j=Sf4*e>$cz7Mt4+C&f!$Zk})aHzN09*By@@ zcQ!W832+c>6lz|)zZ8Z$X~@NILq69_AtLp&M}3GGpQ{l;CB*Ob%Jj4<)F+}Y5t((* z-xl9)7hF1;rjC#u=WA{#a9j0oS@% zHG9R?QB~ZVw;d6YbCKsYp#U+8cq<(|RRlxK%3XZ6nEwOj?!E?bfC^VJOkQGWvIY{4 zv3e8#V3YhgoN>LnE6NwS?HW-60Tx|>fM0daB8EjjtNW))C!m=xW*V)mAH6hOXC#Ga zvZMrFl&G_4rcSp^S~kS`CDPsun;(6Cp}+n9{&wOH3#V~-4Q&@TKL$K5Gp|>{Hgzf~ zB3S@i4Xzns>9fxU55GePws}n4s_AiF4K&Rm4uy@~Sy(o@hLlT@&!kBwshR>t6;2f# z=s>tZe$`SvzP)9q_28foi}UHGCE(YDJ1OfVRxdgknIu^u66#)D(8YG=Y`NpaY6@{f z*d7CkGlFmRMdqdv2@j=T)!f;GJDXfQz8`; zb4$`rxq(M5wlt=gkjFdGW%7GZ#|HAH+ZOtbA~SrWQ#DsyHT0E}kP6 zR80~Hde1-dw8z=KGqzUog+HX$Dxyd{aJ~9SqxdpsXN!g~2>_1V9}#Qie?2zImQBy+ zt0%c_XZ4T@H9a0O{D{YnkV2c_P1beQoiDz;Xe!?v_>P~Tcg*q{b-H2@m4F!9f}6UG zK1pyWdBJ9lpGwo-o`WM+>uAi#?p5u_BkQ8+J7P$EC}D6)|IAZvRJa5F zZe!#9{stGAek9g-Hd&yYJ~oaThakq(T8>$7lR;~{7un%BRr^ab2dQYnHm4QUgyoyJ zc3aD1_f?8A^|8Z7=1VeQQDw$Wn2#Y5x=T}%i(de&eXL~GNq+(%hPKP(EqbN&nHl2U zH+DW({`X9~nQrvno2v-W5eaYZC?(*BnMFkJ4FF%e&zuDNTEDzD{khKC73!^7?C`nn z6X6&7XaHWkv<38JS_byBN2aemKQHCC?$umIs=B%jlxhbCnd8!=(#0bOum5wBu_1se zk+2Gp_N}7oMdR|S^s9#x)(o7175N3YZ~=Fy(es$m<%zZny6T+4ePzWPGCOo|G$Bn~ zez2e)5(jS#?&MHPI2QVGTXire65@NdHhF_5*!At}CsoZpxp#NFj{>DHrg^JvK?Y5e zKRB=6rHi=O@|qwjW5V6Abp!0{Adpx3L_~4Q(oW*(9(aSdv&J_?u=Y zc0O4@_sE`0~Br8=Be(nyxoQ|qkU zz3B+NK?O+1-ncz|k4zTr^XscR&L1c}A_0{g724(*C#4fbugV0p#w7vMi#}VvnAspB z&bg6v^7V>~hxVvVz)b(MV)qQC#Mhq!-uHcZOUx{p>qdn6?!n^-{o1nQP39 z#No1qLE?%AJpMXBRFHn5^uV?B8x@@VV1&p9LurGeb}Ur(?iYJvCi#Rai6Z**2C1#! zmAu=!m*c!1Cy&&ezjRK3UK_m|GvFb)JTH;;?U`+jbcCN%R1@w;scE2>Rq&8w6K4Z;ZVKe&wG# zPnb6jE%&9g19e|5PPnu(7 zCrV$0Rv4gK(wpv;U4$B>#G*?JRJ(Sbu(fD=d*snIWro&r;h%x6XfZ)TgywH8FBco? zqOaD7!e<7GZAo5*mM#YknLzd7KpwZT4GWnL-(yAu`tSAdjSt(d-J5IKIlx4yka)wR zYrFT={1Dswk3YAH>*Ko=5lOul_Tie{@Cycp&~kQ+d=HQFADSE%`hB3O| z*2{M5&YLE^{P{!A6!u|oZc@=$*|lvQ@*JZ6*Qy(mQ2TFS^EVg}BXjUrJzGvg>0;vg za&JSEh}cUsg+CJ11!u+cCp&1tf&~OaB$|(yA8Ld4MGo?hFf)`DwNCRn&K=@aE7w0d zrfOj4Br!=|fDQ)-1|gA^J!K+&=@iImhMmHC#1p!L*iB#@K<< z@O(sCii*n>bxj`d*mMiW}#91w(^RbTaqM$!I$ATFeHBypA?1?j? zU$Yv27W(04p|35x9?Modyly~O5q^Ng5J_Is6*HDK3jczNK!M@D78LEsiv-*VXnxt3 z!5k={&M$2hCV0*>eP)Utc%N0v>@aayr`xUStfSm;?a87?J*WFWRyElnLzbabSYk2c z0r9CCx0sL!jtLE%Y$}1Q}lX`#u#!AwXz*pu;mW{qUsBr|-N z-RtjBFxY%ozon@bz?{1if9~bcqA0ZQC169Xv%@)uB?ZwNS_rDzol)Q48noeNgLwUP zZq_NX|2RemF+i@@+zgPlV5;KY^I@^*p2pge>C&s`#RdIF@~D=~oD$%ofwPOV=oA!n z=rH8|*KzXi0Jq<`;eq}Hby*|afvkJf^&@LFp}y|?1}pi5xZtBJ+8XSrbXM9o!Q?z7 zCGEXH!ml6o^&&!9r;i&OOgU#8aN%j)au~US@cWIy&1Nl%)Q9SlURw1Lq*<^hN)`t0 zC-_$+nZ_RQoAr zgaJhrpUa7!3T#eO_kNOHsVlms&`)x)4`6{bGdmnoP*8D|u<@30C%hrOjW4UG7Nf*R zro5VqY1V6T_5GIfX3ITIeDLq`iN4EF6m?~KtP!%!z9-opibbtXjr?RFr5e9Vlp0h2 z{g~eGbQe&5Tt(H-Y&DGrW9dAkHjDsY?HS4{4TTpT{_(`nT<~Oig41hjho?5C#&obL z-FVl|h+tNF3;MHP%iPWTLv@t`JS@zOQ8=8l+%i$v&>}UVs$>SO`zb0g5D9BW2W$~k zd{^GY!oq(CrPkN_nHf$JM@pipZd|2GEvBCJsWCS?2Cbv?if;*qf1xpnk=!=Boc`~HTa{0&?!kB~-lEem41Mvw+nczm(pxx@)h>gv zdkR$`R&TL=3ghRzxu|x7^yKQc4Feyb5ytu`7z%YsV6(rZ?6{5xN)G^PVHy+;6HY-u z9*Hc8q}NgEYI#dF$DH7}eRq5i7j7R4F-B-SSu9*`2C7iE z_`13QuuJ>`0H&*$9DaM|AR3Coa(%i8(idnND7Sgq zGkG-DG#4ne52yP{VCqHvH+`oh*I5*bJgVxF-SYU?s54)eViwxzDuY0tUhT{V)YJHi z@Sh|#>waE!(q=^N$GZ&+ViW#Znte#hmwE^wm5(OH_$fU$nx4^97Jufmp2go+tmM!U zlNDW)TuDVSnNXxH+*uKnlRMJs%9xQ+rnNPu@OnRx-xCr=@>v2)@cFmfDc{|awdV%R zFOi7=up)ITrTaM9;~{j%7Ii(y7)XUrvaaa;l!V4r*xsjS_m_XdqaKt-D_}L7SPC zpobr*g|@>CheaX2jQ;xS)6DH%6KFvpfM64<`krN_BH~9;M8NOFRre&3UpIJ*b`;bV zrXR68|9*O;u)9Tozrq6n`2#rPUy)arIl-8JeR(ZOv~@BqJB9CrEbPT(Gbd>hXC&L^)CD$)8PN*uQm@Zl1Mx z*2K-*p6Nxde$N-@Ub5Z_KpJGX^d^8Idm_JDkn~{9`C#RXl7mNr=v20D(gCj3-+ovV zvVMDA_r8H8?Nl59=A?J)N>VXXm+WO?n!kGGO#5aXqVJaQls54r%OO&hFB!#z~8g2D!s%#BPM_jH}|3z$NSu979t0bk=lr)ohK=%m|FFv(PD#O$bjH#U;Qp{^jMW^HXO>cNiJr zb4ZiuFN>4a8TS`o`i%u$s$QkuN*GZ>;{m7}h2q)tjQ;Ic1^n_XC2b8$^!Z(rtE>dP@=oA#NH5Wv>p)JcaQL4JTP|2cGNGi-b80V;9 zMD4OhN?2WFeARkGJ!3x8#eBqD10i&Na@tLP%YW^zmI4HH!G(C)wd;ce21ItxKIPAR zSj7fL{NC82@#9ZODBFyG2{FGBd-LM0F<$Kfx}c_>E%4?wBvY867z1#o!hlrk)+@@j z%AfyuUY_7ls_jg`HY=VP!!aP?;dXW%=BBaQA)`f1oh`OKblhVYtU*)iMnCXFp6)_2 z_h|D7g?-hNR=jwUsJ@^AXX#Laen>vjwfnwM?+>J&siXj-xXVnZm%5f=pnuc}ySuN# zArcc2v2fz=kED|}))nwYBYALu?U%rS3Y^EC)fx|1kBZK#Z}M}ono3qikNm9jRC2TI(wL-dTHL$*8@W4BsGYJ^d&6C*So zW=;L1D-CaZ@#7OPj{XYz;p}f+CRZ54&x_Q{SrJ3i6!AC0AhJO<%Dx;-BvDolg*2YB z%^)BnWW#c~4=~}FpGR2k0WwrJUpU{iVj%FO_CaJXpM{$e_vdWd#V#p8qc^S0Nu<^5 zMK|=fAWL-;gsFx8Zg@19pS1=k!eo)J^;h?6#y+jBd-GE^@M3jFf*>3nV$!fpV`;Xh z20RU5w$lm?#3k49qwgFwLCfT@b9dnedQq9emDRW)Y7Ri3F?ry{D|;q2{b@M#5r%|} z0(dJN>PKu7UJ}23oNW<~5)Ewx7vq7*Q-b~&-aXpAjisE5kiWDGd1q>BvdWM}vnkM_ zq?wCF6!jQcA`ckPw2T$XWtv(5pnDG2n3F0khTw1sBJ>98o)CM@5}Jppr(0PG03KSc@mIZ?w7=x+m}dUMKuF<5 zUtcGH>+Aw;5`>8FJ70_vI-~P{v|0Y8cRfKM2F!c%v63Y&jxkc+j)x2kR&K)9{;m3k zfsioCu&7l$X=S4mhFUwO$WS}y@edEtzRi%4U0;Y`r?K0)x>NyY5~&ZY|Ce9j{L>Y4 zga{v+@ilShFj{I3Q4po^iE849CTBl4!0!lP81k8wC@56$1ULVQq6Dp>U_=}=g;>93 zl~1&11ru}q>?^8XBu@?#8W;F88( zSn`j+=abQ~@>G^RY#wqTjQPeH50r2#d~0nP|Fu7uCN}}wm9oU(NmnwPAsU5I2S!GQ zf9Uv7sagf1{i9&^_YOwjl1b^gx$RNHarWjreQ4{4M&_*X#@bTAV5^I zImx^GdaRYfOrX&hQ6*ei!FCIHl-udES&G*u2G;FoiBDkB>5f=D+o#`f)AfRP2hl(j z#_s(lbJP%$I8mcK^gN)G$BziPY!TGfs;=!AJ`F$r`(JEM0?^pIm=j^?H^}g6I(}Yy zzz!7!Pz!f}_!EWBx$5#mIj#&G<`6;c9K;!n97K8v1g6|CSZtvl&wrip&}(;($XU_U z&2~l*A?>?MSPb&R$kF)pSssp{RO+yHNAO6PIv#o%nj|PiKVCd!zgXl(9pS*&L`}=DJ`vsQ9^y4 z?w*jbl@B*hv6QTGGtgaO>@TPe4zBB7oN4FnUYuE%5iE~o{z4ul%YBq_w;ig7=etFj z{5$zb(IgE4e!H#W@hh!fzN}GaEfI6`LL4N5(m*1_kq$ZuXN%<2!<=CZ0J4(s+xqcv z&2jbi7(q%`Ucj@TqJj1WbPJwTHj)RhZd>)-HJv@jJkWrc7@iR3Ua0lu#G+Y@#}zX| z4zMw%#-9RwI!CdbW3fTx#-HRMja5h+Vz(KfQ9&ReszE^9z+m`DuIc;Rn4Z8MERt$% z>l-Oh>_}4?1vQl$qeP>p>)%qu)xHah&j^~Hc%7I#js*QZ@ZmgZ{WZ$IXbM>ATY#LA za6>GOO$G9eeuZ&FTukbbZ?oxn@0$< zA~eQq6(e`mbd)`v4@ei9^9&@X$ct@c!SryMT`FwxbPHzi%x5xLW_be;ObQ@Q&{W1# z!|8K1tdgG*)_Y_G0<+kS->e>Hdw*blA6Jn{RtfXKa<^Vs9U%kHcb9WQU_@v zdGRSf#=J-Sud@L-beJ-(Gy5p!#4GLIJ6d_rGj46ktmrD4&;2LgP4rv7&1$zb;#v9b zO^jGq|Ii4tl@AeLTZjc(qT4cx*sV{tbuKJp6Ns=?r))Y$=as_#NON7pf7aSfT&-vcCaO|2lLR*bI^ zlhReXalf8>--doQvv}sZZ$$}dpKZ|UOX`S4#vw?z8E)sGvBB0*w4kc?4v4F{4Ubu_mg&|R|ZS#wR;{hzc$H^xZ`;G z*5Cbz`%I-ATJTf58%bP9tP50Oq*IU`cFSQWaUfJB>{5)O{Nq7Dz8<4AhEw@AO!z&f zNA7x1!z{%ul>P8es)b;LZ~ zO{*#W@wrqg>+*f{!i}p91f-hx->%Mk%zmhFRKhs_q&X$T+Q0i@N_CE?sd+v{^{|Pr zm%L%<+i$2hvNQ7YnfK**VyTeo*wMeMkT28%Bf$0nO9c+wke@LIxQ>nQ|{7618|i<*xLj^Mg&4g9(n*x(KW*!S-w9 zz7E*%XYl!fRGtReK)$FgdylfqT}X{0Cw0hK(qY- zQHK+STuFPeM*!^|jp0ftuW^Gb?DEH|wvPN| zx9TG-`zS@AJi!2Y(X?0q23x^3oUPLvk*QxQnKPT~tR2S+9NXvVkk~srFjJmbZGZ2a zBmh5!NaIbCeG#3GWk>3QDQvRRnnrCHc4Jz(bKZO+jQD6lrv__{2&?L5&k#z0X3r{G z*}s45-tR@xgtg9496(r$23-|pJasOeNA(ZYtf@F*NR&a9t^6+Ww!tmpN0^7?E)+^J zBflc#fn>({aV!HRjhp}-d{a-tCMh4PYK(3D$@sf*&yp}yBJ%xlj!nq2J`70m=EVvN zjGzMZj=*#Vd!G?gIS2uSX(&5W#DQjM`)Nl+(`r!V#D??p=xC{Tz8th^PVQntj@b1>~V_hBKKJpfn!0mQ=` zMHG?D8X&uq7(HngUf;7su0IOd2`v~}Gh-fde04B{ph;bsTO2>@BOlZgHk{gs!)$a>j zekLpyUR5SeGK!xdhXd0}xR%2PHi&Hd{ravdVO9~NJ5sloW?TIo(m$*P4>QY;+62;s zn`Yhb?S58P{nSHL3ng;sj`>z{WdGYK%e?htJAXHXEIbyeGKu(ZOoOWOWre^-Dv2AW zb9DLH&-xwbRLkf!ft-OFPw<_!GBbt#p3%497PGj&-U3nPwQ%f~77=77mRR(X!!SJ?(P%KgVRx9BrdYk$zc1XN zB4w9Rr!!mcpc7!bN6@HpHr!BcZIMet!ArDSiw~hcYpf8WT()As!kSPl`%r^NhGld8 zLf)(9Ix1+=kq-tcx8yUTcS?OmT}c$O0t1q()$D0u=e&b~Z?z8~%FOvbRPJ`U0yyNa zcyI_xhi=$Ty<8RufV1!2?zfMMm*?m>paOaWMgB9qWA+_NgjCXOq#aOIFwVRzyvsM{vYCSxZ z@BUOEUtmZV*_+2`zH{4rv?yi^hbL0Go#T+Kkn*Y&g=?TebDz^JeFJ}n> z`YEI;m1ZoJi$JVNzmi%Xe1J8{{K{ zN#@J1*01370>w1>ZGd0Vb{C&*KHE@_8hoTmvZNcV4f{={ghSc->gQ{#|2uKa_Y|S$ zN7YvouNAya3OPS)zuE~tY1bWKjO{1Z2IeW-QR=pp$qHna+Fh2a38oDi{$BMS`Sa(r z#WuM9(VL4Wyz~D?K_Ej01OhVc#!1AEk?})I?J04|8M>o6qu`tIhSGQz?c978q2(GE zo0U)kvlrMZ{;jh4(8uGDK)L|(&)-1T^znAw1XNe4ZV{{R&#E;0uI6EQZ4XIZJ!n9% z${MYyG3_g9PZj3`xeWWW{n1@D21jbzuCzcBXuiq~)j$$YyJJgphSRJu~*Dk|F8No)!Bz_zQjV-9*2n^8ekP9E2uWUe8d4q zRu}sfzbcxMHku!qL%yFD_R$vr@jT8_qSs(|7X^ugBoRDutW<0b);vJG7`9 zXZPJM*KR|ZYkR7v`7WM?DNmhq9|Rhu4LYaTIZjxHGWc5L3t^Zx#xBIr0m-L0{!k6!%H7ACmpd9rPT}K`f4!~EI-lieh!t7z5S(ImMaSiP z8vp*&TIZ%H^jK}Ova}J;!?i05+<|2&Fh@bm(Q?NrO^F}x1Q721Hu0*hfh%e@E{SO4 z=v(4b$J`vAr~`$`!^O*r8b+l3Qq--s3qbsjdCD#eJ+CQ!e_`b!sffs)asd`SE!%Sp zvL~iw!SGvH!{3tM{uRl{4g4d2(zvy*5*GOQl6Jpg^CYc}yZ*jU%EmL0)ocxA$;`&g9$S617Knoj>ZOuCE6{(_>0j%%$3l~q$1Hp91wG5Lp ztkPC!0nt3*H3n38TNs<3*IaQe(@#jUOoAvI7t&;Trr-^QI3}%M!vhB9B38>h&UCU$ zl#9@WYcLjW=|XjlKwHDZl*nuGgwSP`kuCH0UcRaOQXm+@@{r>jhBB^T)@O~b!iXK0 zb|`M4i__B`4ij>0%@b&Fwt6Q)>(}!mYK*Y+M*CBIo^StDLmN}Jp6S89jl`e?`E=={ z<*=RSCnG_&4o8?1Tg(8nw34I4tK)g^=gou(VUO2Oq&04~>G3KHI1_l$X2*I{OUqZf z)Hse+kHcE74p&uOQvuxk=&|HCQL8MfNe>(k`*KchWg6DI`PE>(BS~1wHMzz1mlrx>LkS#!r-^8CCpW;U*Bx; zmhDdK?-dk?vS7D7pWhb@ruIp$8-SD`MHI#xx#dbgP8@E+S;Hw_fuh~%bX(B6Jd`wQ z(<5)2VDY6JKBvK%Dm-S%wYq#fyd+cOebCwjuR__<&;r3|Mwvw~4L7jkI~YREr)_PGn{JtPyOdxv?9~D`>_JER9;{^3 zi|u)Ik*l6N=IYGQga9NmT@U@c)7pDB>;$3b$5Oq!RS!$=HOt>h9Ckl$N1Dt%$Bz94 z_a;L#89JWY`b1u*5b=`N77tcqQp1p**eE0}ChysH@XTZ2w=#Ys%PIcsBc+sLzGA&Vq<0)9eB48S~`kjrm zYbh~)GBL~=OIq>H(#*pJs`y-dAMblS{V#5wKuYsUl7yOGC$b;d5L;mdg$P=k4N!+^}X6?TeJu!e?*w`WA#W#QHG0)y*v0XvG>o`v-O+c zUtG8D+@Fk7z^2o6r^;&`*1xZpMN7VN6j~o)#3Ec6-yG)>=xfkX>4#p}T(gAiE?Qk0 z{&8}#(9fRO?-!ppML0y zR$Zp6oYvb+^1?9Lp*rTRuGoH5{wvos6IlhYI@?UXmHY@vOG%X?qdqLg$=FxlOlN!C zRzq}u*p7BFKrGpd6Q0 zH+#VGr0+4-{e53RdZlH3KQHhdy4JVPH+&^#fB{79%uw}<=)Z1lOnv0}=U)?&|Yr1%u zA^!hj9ocB6KK6e4Y&N=(+P#puh+_(Y&!7rB!k%zaXq`+{g7cAeRNHLnz1dd^+J)!| z>DziinMwN^Uoa5l3BkhmuunOEw_HCnZ!<7*pal!2{WKadi#7FHZ)IP7M6OSC727=O>JZd^ zyUaAHhh69qN|G43dSE#>d|qsQ`^Ju#ni5vaER$A+&TTBnaKUJT-7OiqWB0OqvHn`A z_R`K#BoWLk`#K?D;V(1CrTELX{du0${XXtfzDlxb6GH_Ogm1N*%A7eVOct4*=Ig~4 zsmI3p>rpYr$0aNutdI4g`IEH;S9|3iXV8aiyN(p3m#)g3I3$SlSJ%q3O|6^*8@zR= zgE+op*+U4M z-v4Bl<>vNs?4#@RB66&X4RaPK0%~#Bel9ri54hNi=&G*OW^+z*rTbFFVBmeRz%kL$v<{nL?61p(_|8|;9N&ai z2no(UIb=`&i`({q^^@k@-I)vW;;(|z*7>rfXpxL>>|F^;a|X{wZ%-o6R7dj3s}%&{ zW}P|H7blLL(+uT9wXVAj7ct%d`@tF!L&v)G=yZnD!Pfi8l{I7I`ry2fWpe%bgvOIL zd^2`R>^&lpUw8p;#?Cy{CTV(?Buy5UDJ{!R@i_CK1cx&=BBPmLMFY({$Zc_<_a8C# zUFwrOVV$vYY9$QHr#x(y-+ESMG%n89d?^z6*$e$H58nd{efoD}*`5|FSTS^7LFQos zotcT;GD&$hxGym?I~V~zKT=*nc5a~2kgiSFzHT>zD5!VybM*oVyIIm0`?PN};&9rB z8V!&=ggOxQV^<%?9(m>g9@y*ZUi$ve>pd#BK)+d#Ynt1jF6Lb*2Zhwk0dkXOplmFo z1C9PU#)`|~wv58z*c`=y4R!j+Tyi#FK86r($93VZwLyaROI(*BX+}oqBLsfZmzHKc z)aG*yES@0+EM{VO=0tWO;;GNY!(RR!@|LJxzuI);-YB7vx1jgS(QAakb#?pe>*T$p zbqpp;z)#s~QTVt|<9y$OhcF2#G*s?&|^IAa+_PWnD{3I zmHzFLzHPE1R7~VDKSMF?KQ|3}*}>~{k(0#P5MR6(1MXW)70H!P+lGj>St6iPt4J|6 z_Euaj%)2ikta93~Rp*l5Dvvwo`mB||FErz;tD zec0b!nmFy~`19uNvyHU=6ScbHuLWe3*GE6WWOlI*G}F@4bMd{i`Gz?M>;P_*k6yI& zkkCQZ#xjfbg>Z*#^(5TPhLGxe0AzygCqYeFin^)zM0jUKCSt(^k&N) z5{9BYzKn}Ba;#3iDMRds!x~>-ZJ|Q&jz{QbrcOy{_WH^FIQ7qkq`qEZ;*E%#>iDmD zwc-LxkYW9$urUS=6?z^xO;{yH0pNRSQxWy1o};H(?O%T8NFjv|0%hQ5-;!i{2or77Vx_SDV7S2HWzFgZqV3N`Hs$`xr(lI?KbavjQKMQi zU)emV-@_IAKD}lGpB;>Na5t>sYON($LfsP`WkZpA<(b-lN#_M(<|L1OF;SzV85a99 z6n%`RdunS&5a3`BX=pBec+9^{~5-IV=abZXau-9OeA^5E9D;*f<{ zt$1@wO-0UXf2hBR8p1|l3Z@SWXlgV^Qf5CzDEmd#Z4h2@dl-N7q}8b`%KcYjwTHv+ zLUwy?pTSjeV!^e9gis9W=)#%9JELV}2HH?{Oq~(dFG29BZoPt`?9ff)1!g+JyhNrS zWOBy~+jHzStc361UzGWA#&VM>&G?47lA&NyO>GeqYv$&GQd2+*&DNVF0M)s3A=^pF zII4FcN4dGAXf?=+@>bc1WTHzjB^pCjgS$KoTVh)^K5(paq1{QyI;+eVrB6PDl9JBpg+nmh2rorsVR{MUj^(Jv9DMuFI6MSU`_qMkzn2}R$$(! z7i*;k46??2HIi(Z`W$iAlpMw<`CcWc@vk0m!jNFT3q|aF7~!^SnbW2C;;+Z5h@Xe& zO$<+u871S(FT*HqtkVW1cmu&23Zv;93+IH39)9I+qn;g1e7QNPRvDhaIg=F>u3`J2 zUQ(x#Pe}qKwEBV>Rl2sja^J@l5n|G|ImvN1AFHX02A7Z}AXQifWaAJ}LddX1zDmHoy8%{iyR{mB$FM0elYRt<<&67_T?&bx39zwy@b?4Jw12zpZW|J zBf~=eIj2$4Sx07ZgP-!sur?DM8DPn@$gTPp&*Jdw%oUOI?IibgLH94*@;B2wG#C(pr5@${#3j{ zI9w``{u0uCplIn(6lLULUq@pviHoP1>;?+#l4a4aon`3+mDJC_cqQPFRg{NA9g-*~ z=5)i1P(aw`WeS@qjUko<@L{nS*+?q1lg(T*vf)|^e|B?p&hlOZWZ%6fqrAix)A)>* zgoq`86&h-#j$GD|cWQ{=GV-CYOsOJfjx?t*SZf0CYLB=zZWvA?nb1^U*@y+HN{!Nf$zwrRTPCVbdYKjYXHH;QT@fkZtuL?Yfv z^}CZ`g5;gL$(++)22MYVQlt}Kc~1N&HtsT66LlGhhJ_Q-7Vw4^*Eed+K0LktD6|aHfE6V5!%BspV66@|-l0h6JbTHs8wcECEyc+QJ`triVv+8a=1yFDxc~9%AB2 zI;GTOkdHD;HGz~OvDEMubU)-w6ik>nS!5&ZmKAVpuw(d%6LrJ#eZL~R(L%m{uu%U_ zMpYla5m_AryYNo<`UJyQ!sIsEr+iV|?JXtJPkCJ0;|3;lNng0PmsGiu%(NRMxoA^H z!*Ub)@g`n>l!wOOr|&}9RE{oyNP0MhKw>E-xVI{B?k{!NDCZ3aKB2wtW;~cI?5N#) zZb6)$%7LN`rIfzl$=FiK>||3wtujEwZ4v~%e=5c(EX{UaWJ{tOtu3QLQC3kHQFM`3 zk->DEMVRWfr{<(_32xbD0EwyzrR|()q|wg@LhR#a=n^_?r7S8Sb6mF4o_d=Pa;0}; zEXB^fcQ;pT*;FL)is~L^gkkXF{O1ltdVh5&H$LhoG;12PgdJ=$<37t6h>Vy?n92#9 zDN`Wf@~3DjLEk`?kj5O<6pR6T+mt(y-4;cKQ(Z#VjnVGBD?JXy(Pc)ia9p}2^eK35 z1{5{=erhYdI+};+p4cwd4Z1H5lQ+o8V5@~mZe4k%vk24WsaBFS9Ng=agxc;_lm5Cc z;ddj~wjd~M^kwAI1?RoROWQjt7);CbMvb<-x#q%J@{88qx}9y0tO15KLGR^Gwrqz} z1a1a0smhfaON^9)j~A^nWcFcu8qA4xq{EFUvs7Dl>jknaCQy@ACo=IFL_(P9=UokB zDD-b>KPp@Hd+qXJsTb}p(;8&Qji(7Gv{ozoMHSyLlvo)~-dJag2NSKNXYjbJ;L#CH z`A`7r$Zp?-r8!RK#N{$nO?OWzG_dJJU0R1^Q@#+Fufy%sM^`iA0=eM0^q2GM)wYj2f3ewT!L@cBsr1j0L&frzQIWz#jCPT!`x2@A3Qm{`!* zC7JqG{`A4us#FK4B|9;7Gs;v8lL@lqEsBWdC73OAGZfl!GPKr|Z+c;Yu(M0Yzh*R* zGDd=Xml>&-iWgKe9MU{3^hv5FdL{~{`PnaCLLS@i^nTHrLm?|iyPve5gZ^gLE`Bpk z79EvIC4qY{>)|q!#}Rd;GG1Qs@Hq7IsGaBElh|BKkBt^+Ix8Ok0k*n^P{#v_j%A+C zPFW7ORKuJigNP+m7wI)=ac(uMceYgoa~ZaugtGQzb;k&25RORK`ID&Va8ps5y3TQ| zdkz*8j+CkO$wd0$h4m>0D2Kq)sQ%F|{FSCt2!uUn>{+?;C^8*Y?Wpw!A$0nN1xJ4F zDW?QetJf<}9w$uRYF5=m%@jLh&pcyYr}wVzzmfxZ^=R4j@(p?BSn}Bgah6FL#PDI?9_D%Tx)L{9+@tELr z6Ih*n+$f`-65}^&c+Hoai77*zN5Pd;rd6s=1ANVildk zSf%+QI~nE~m*x~-OQZ5dI9Bib4WHcx{(uUER}oN$e=FoX&b3{U+g?1Xh|E1MlJd=e}4A@jH zgwGMvV;xZ&D}usTIRxIdJkRoM&8UgxaB)#Z?v5?5S~tfvd_FnpFG$CaJrlkkFiYBA zMxjNK0LvnGY;Ng|k>>71)T+IQ0Ypeff6B38B1%-QSa}ElS*3!tL~+mc#8FM0>_-r@*kmq84UeesE`&;Sympe(~b=h94|vF!lQZKPlC*ZU@Z7q9bTeqrCoN4_`(<2$Uo-wGeAavBcRyLHrrxL2PgZNx%RI(M6{ zrG5=Z2t)~Wnk_D9bYfvd3B>L+EgvI9Wh}qKzSiHd5DFO8CE{_LIfsGal22lV0uf;w9k%C!)0eDs1!0 z+-mN>L^@@PMuKVz9eTEF`8v)>=F6lnORno@J1;S{t9B>ejZdKibE~oVF8nT^>LNC{ zk_ba{H;>HKWsOtPo@B(#Us1}Y2_|ND#CQ66j9tBi-LGC*SWeyoUiYu&K60JL)`ToZ zMlJ4z-;x%H&4cm0agBIG9FU3zmL%}Cf;Xb9Cdh5t=`Wqr>L^&1=u!znXW z6T(WzhccSLRvNiBlzM9_p8fjnoqzQrj~nswGFhza%yAX!7UYU_T0=-3MURQ4eN@F^ zM#sql6UK|>`BG8+OEaw`Ik2Rb?jrJzrfe~wZmgPX2WK^s0rFtK4cl=k~x7X zNUwaG<8&$e^zCPJ@Uzfsl#xCD)qj7n$N#bS=J7gK-~a#N9A}=8IrEr#R*@u>nc^)& zB_xU@MUiMWl_IG$NF@{%3P~z5luBiuBV>*;5Bv9e?)zS+tGlB&eZG(1U+?pHT#xI% z?{lp^thM%<_r4O+nmzya>Q1*$o|%2@jt-YsTYqBjqZRv}-nHVf25C1BTX=TZr|#!2 zzqRg~nqH||+OSvZ53ky4%gK|?O5Q!v*HrD>tq_c4@)`&3+j+aQW9aj_Gkjr<|{@nziu#$ydMpeu0}ybT5?SigDA%*4gmP z_jUG;zPk6OqVgMal)kIp%m&d>^(u^6vpQ+o*vSL${P<{v9-G=XT--h8t+#s5EBx#pQB4Nvd*{*UW!?c8tWy2rZx=cT2KU#fELU8mP%FB-G3b-Uf&JEk=l(q-o1 zaZPJnGy1`y$12|baPNVu59Xcwa;|z=_Afj)`u8uEwkb8D+2aj2eA?p2LfuMrd2`sx zI!h`P8G3p3(z&;7ex>5<8#~O|xU_4Qt?r9+Cw^KHx4uy4Te=sz|H%5r4~?#u+~v;R z{mW1I;?c_o51O$d-;gSAPpmn=Z{<_7tHiC}U#aPi8{`>+3K z#JLsUm3p!E@>4Ume0=!$f}cwdd~EdCeE9|q{r2Hq-8%nJy#JF03*5DC+O$cnviE2_ zdH23|=J&aL^w#^Dr{~#TZQ_i%T`xb^yyodqS1s#5uIKfWubY1L&>BlBmo8W2-7+O! zsn!418_!;{G3V`fK015Z_n%a}FZ+UB1q(%Wi#jlRVdX8y54A0|tB2xf4+a$m$gdgetdeRsr$y%ZN2^Hdv@M>(}0{C2QS&*wa}QJU+oxPb^BZG z>b&#Ev@d7vsW9xPTdSUXX5gODLl$+PGpl`a+lNxNQIcHhhMlhd=8EB0J; zmmar#_Up!qM{0h2$I31z4u3j#?22cqf8K^GHJHr9&T4T4n2}9~9|y|MIf+<8JGeul(TG zz8z8JbdGbc&0X3lJx{ZI%j%DPeBtC$&m1m)WA?M}Zho-w*0)CNO8H{Z&LN)-Jyf`V z&Q4$KU-{C)ky9F^bt_h&!FyGczHOS+{>@rBz8(2`zxBNr@0k65^CG!RO&Bv_ z+BKaU41Y8Jx*uQuC`W^KpU$89%%M`BefvzelY?Gb+Ute&<+C6CX>PGD#b%#)xM!Q2 zUd-~rz$Z5B|IehS26X9KvEb`-U(a+;;) zuHwd+1!?(bjh@@GPLuez8$8^(f8z?(6N}bgHRZ}lk9=5bYO`5e1`YoG%W>PQ6={F? z?tRZpeki(ii+lF;|LTJ*6V{Z@nYC@}=zG^}E_=BCn$z`aoc*H3$sguy*|D`%|3hgX z^qRG?P1Db(RqwI-rg=x>q9)awG@`^~$+62`jQ;YS>GON$iR+hb+lb@YM_<-^P>z__ zt9E_0O014|tTT1ky^XdHAM{rAkMajsT-&qfd*kEAZ(Xu0s_*CrUTLs#c(txoyQbtU z@nrhG_~^X<$q|27&ea_UEt|Wq;@*klhxOT8nco{MP-o(r-VtE5}zG zo4>MfaVx6!f1^;ZO(`n|x4Ne1jZLrU*S*)S zSGrDG_VlA|+Uxy`Ia)31l=SI`Pt90$O_tAJ9Ng=LVFP=tFMZYa6)%3dVZ}}5immLh zDn0L{#mjrVll8j0(pKM`XI``0X7yT;Wm2Kmqc8ue<@U2re3Y-=Z?|mA7F&Ns*epvYM&ayM(#vJ&( z&dt}x)a;gAdTHHUj~|#{C;igHFFr8#K-qIY$JXnZV}6rs8Z@fWzujQHD056g{%2=Q z9{c3vl7*hlS0z{Wj^h(X^}o7agJ*Kg%`tgLj#gLxn7!}u;YBMycjMQ??wwS(-=QYk zI%N60PHetbExKh%x_9F20w1m#)AjL*6XP39iaPk*t_IOv+x5Tk>RvC@UfJM&3>#fAu&gzODbMJDE+qivo}wzc=HW$&AZ=w^2_fZDt1r3(s{0%z9xU)*B@+r z|B~)8RV&Om`0eZUD=&Yc+JR=D)ZI}3=3Sp`I?%G|$-avR*KFGC?67Z^w%mNx`nLw8 zR;kdbSpPe2KhWyi&$9K+(qQnexbs@-A&NdVc!omK8of(6U|EX=QVaeW~HF)<4b7+Ou|Sjuz_l{U?Xl#k*{&!#p-7qetIqvr`tX@|N4?ek<4KnmpE~*V>K~*$+h}6R zuj>`MXa4ZC>qn%07yn@Gp{pDH{Cw^_&8K~`>Fo(iraf0C`*rm@zB7Js^w2RiZd%*C zaoa9E>Qwn+Nw-^8J=m?pi*>)qvZ+F)c6k>~`>bGxgtl)_%hC0{<&Ui!QKG=G>SJS@ z7o7U)iT+LRnYUqP$00-We%H8D>5k7fdUi^qtRsuX4F9lbvFCC>@=Cq$$}XRAbK6pz zKXSLDi2OpYw`IC041MnV66}b#d<>^Sw7Id)@Vg z?!5BVX{BDtG5g6jm%YE>o?H8_U)p2!7bWL>IHPs`qxH8fZr-YGj~kXZAF%qGwpVsr zTKm@iJF>qpV_&V8k7R$e@tjQ+ay5PQ`eECws7Ul)?IqMwlvp> ztd}f0`RlDE@9pu%nV4rwyi+Lq@G3vd-_<;Jdc(;>W8BvjH+<5ze6Mz+a$hoK`G*o$ z*B1XU$J91WerPf#^}QBR!_TeGR&qkEaxoL9zLs@mme#ckPt4o!p-~?#Zqj9H-xmt~ zu;INP6%IeNd&s%e!cjABx~z7S8fRZCHR#jDw_a0xZ`)5t#a>XPk7;r$IIm3P-xn#wF;DIeIn;=bEdx5Y3}u(G<)cobIoq7+v54DPtF_DW=`43 zn;O?1So`4tG3kr$x;gdmk?BpNUOsjCvX2`TJ+S7A5tBb0H*m<_j(a}8s_m=OnkiLt z^Rd_NJax8z#g+wUA8jyd+SC#C2Q0t*v1V=G$uXzRz8S+SjV{|Ns`=5J!}q**>8_f$ zO}eJUu-I`EdoOH~dhLzRrPSMdD`E>8LX%F;% zu4CQar*c(@ui3l6-o1ybzklnVXF6m_JlCzp*_z9yKL2c^kFwOsy`%VjH(!0tgV|pm zFQ<0E51%CT*>T6%KE*05KG67^=r7%@t?K*uz7>j=?zOgzOKzuJ@b2ud!H!v z?D}5&IyP9}|IC5aTgq*?G$Sm>5x5n!(F=$w7+6{ooTZk zufFMW_fC~pwrt)sG3tq3*>nRVrLa~>7ozZ62Zfg&>-~RH~ zB?_NOTs7d#%6hUeOY^VsiOeg!U1EJ z%-=ilvxk@LT-xbe#c^Xg|4_BZh83$nO=xh(w364WiQ(_R{#m1+uAY%2X>qXvZ#-Oa z-{7I&Ms=ugPuA#d9Y;pJ`bhfOrt*sK`lDU8m0f%En6`A*_T8iA7wS;z>GA#B_gVWw zll!NYT{->RkFM^$VavRx@t0)j@pa(>v-Xat{bQ5*jgQ=W-I*IcD!S~x-^&r3I`r8$ zWs7aCleGA~2Zn5~kh5Fux}P>ldA?Y#obARA5>ijD{^PsqOTK$z*Gr$e?Ar^?UccqW zkKTW_QJ=>3e*1p<>t`2T(V^e?<`X-d+WX;q$FJ#nEc*VLN1EqskZ0iyuRb?z*}SJ` zxt`;*_S)Dyx%bzF=by>F@0qMA)%Q=CbTW5R_6~Q?INQF)JlEkZw|nQbvst=aeslAM zcg>nGs&=z(S8nK7?9hYt+Uy&6?CjB5?usYZ&X|1X%IRY|uHHX?Mf8M%Z?>rOaEsKK zOFEoBReHj1H@D)DhmN+rw%&W)uO9lsn$0V^$B%pdlP8|6S-0mOm6}&P^Hs0k`+Rcs zylE#^wYhru;Tp2G>ab!zwHy&N?`;Z>{wC2l~90+C6>Z)OQQ_dF^zc z&mKHDz50i1cK%ZL^Z93LZolT`BRQ|Gc7M@&^?yIJYu?q!6`!+D&cyPSTj#eP-P`cYcrAz0xWlZ~NHS<)55&sMkYLD~f-7dU&to zyK=1k;uE!sHugR=?-u=DiyFChQ zZTZWntDc`Y@y8s8w>(#B?ye^)jcc&|-6qp-8T`<|-P?b9yZ_MY3#ZPjc{u0CXI>rg z{rJSAqo*XC$Y1M=ao=nlvZBDVXAhm|-+PAZJAKEF-o?Hd(5~UyE6;uO?xY7#UYBRc z`}@Z&nAz^w*SD-MH|X{Y`?AxGJ>sH@*SbHp=!q^jMd`0`!xjx@)bFgVK2dsarv7wd zW|pWTe9~W*sGKUq<_i2deg5C|KOFpz2mZ$c|KoxG@xcFh;D0=jDG$h$a9sb^Uicq; z2!H<;hlam@3;%EEMqkkpG|#HA2Bs^{Y{|QfDkvO}U{xgG*oYOzy0{F=OGHdgE zZDfY8i-A91yZ`O?AkLz*M7i8C(JnPQYX;pT=M>pq5T4JM2tMs1;At<|2Jkro@WKB@ z_HEyTW6UntoH2in|KGsp(innp!Ozxb@E+_xC2LlXgKSx{WZ>{(;FASU|8W8MVEe&- z|F55IT(o~n_GI@)!CY=mk-Tn3;oR<#JlS3G*ld0d=j-3#8AqG6B=_2-x!gxZ^0*HQ z=W$Qv&EYD<$9nkSbLSg#gX9GFQh`f6{D*2|biSPK%Eb8p3U6)KNs4!4^XGIk1v^XE z^96D`+B{!>_Pfokazd;dl`n^fXAUo4dWmb9nwSA^{TQ6x4IW%QmN&a_m&eZmTy_#p zbwKSu&cWdGisl1zr@QIG{m1J6?LxWS9XV57Le>x;*>l$K|MhP3Va+q|pGp>RKkDNC zgRT`N@@p)4GHCcu{Xd{_ugnDg+Yp9dsn3ibSyCk-?r-om z7i8^wT64_d$1ps2_(7i;*C(RuwP878eFo6GT*(&ArubUEXP27)yj zY}R~`$8U>9W|J8_WB9k1wUIAdw8tImZo9^NsA4g9vc_fZk4nYep34fl%^J^V!fhn| z3_ezK8Y?}^9Jgw$`^pz}zf~*ac2y`QnG&Ku`tU!Q(9g#Hi1>$f$~?D;cXn4P<+fEQ z?sWja1Alv%e%3Fr_PN(3sUH8Vm35-qj>@In){4d5j~e?T{RaQtpDX=uxH9~=*VwQb zSnI3dzse=u_DUt(TFnQVF4gbDq#wA^_*V+n>j?V#Ml@erv4mTt z{+9}$*s|DRw@5}9&qTssFB@-?#)!?eOgy+oyth`@xBC29vAk}Ybi+N8QPy81Ja*?> zTA#?EjiUb%(f_pQe@yh>FPyTr9+NE`AGYHn;Va5^KnBBS$lnu!cUpsIwHA+v20x1i zuLpFf;qYQ<9{D`u;J3Hc_7SbSLmKPp@`ZiBXDb)?GGM*>9w9qCGyQFLZ7b1cw(z`M z<6kHIZ_pfm(w+72uI4pDvafI^yo=pQ|8Ticu=!UOZjY!>SGA-&rT$K9?58Bde-{tW)tKr<_)v)&Z_qcz zHhmy>b}vI02nWb)uJaIQ+J9FqKo1nbL1U&e=N_^f&zd`di)IaMU|2t23j?DE| zwa2)Ce^7myT}&Izq({&LtAw{h<%+nSx<>0c)7#Ljt>!a4%x6PnQ(h(6XME65G=T56 zNq)MDMcr|&#mQPj<-)R$HN#rMSAR?T3SP(djn~|54%{#HGCwX&H0Y-Go{&9ux8_|k zz;ozd*3_q3-^ghEGHe#?;(}q>&OFL%tmxw#^gMo&|z^e~0FZOw0_H-{1rA48HM^@r%v3e^Y#nZnOACW^I5I zWIHiMYBiRtXm04xa-XgLRGUW?q@WVWUbcw$?>EXmS}a^*GqJXj*-_%T zEYX^S?tgyH>g~628UwUit}(2UfA@pzsxJkPt%&X2TI(Y!i)^aD!Dn&JB}dWao_-p` z>Ix;?kMa)}ix$MU(IMCg(a6vMeAe*i1{xdB5QkV=qJZ11{`V+GuuC)`W(FTWq%~qT zrs2+TLF^G6Es(riqv!Vt_Gmahuv<7>tuZmb91-+0c;Z9YvgjPv&ms9079TjMF+c~} zsFq2L)97$9cgAmXu=o!2->$xo`S?ItA0ODIe&K2KvdJ$Sv%%9ZHXnR~+}k2Q^Jn?D zKZ*}#>o;t<2lM81S8I*)Y!J@I+(~O|r10~)a4<(SUsArf`=U%?H(h;`?-?k)e7$IF z&)ePFg8rilC~8SbE~C^pF`PM~!AkWH z{dddH+a{bK6Z%Rw+xj&)!$l?01wRPii1@%Cn*TYip_B5n4vBum9EWQSpr`0N5*|AU z`G>wDK5&xwfMPVRl45o8+xDpq#!)3;%i0_+=FWJnZ{SS+-mbNQFOR&!Ph{L@#e-`# zmv@w-dP4F$pX?rBY|cS=Vu!>~J{SKJQ~6rgeBlv)`ytKyjEfa)R&=El<9tAK7%upiM8h`<x6s!HnRZ@XF*($kA7VJAfwS42ZTdx z`%}WCMLigp%UE+r`UCLc|xn_AUaRb!Gu!71fi{G%t?~%;CO|tp= zJX$*sKIoD^`^=?%_gx77haX((*I&Ejk3V(^{rkK6g$lTPB}bkRJp2lLU+LV=qH9zA zp8cLaF7cC3LhwKS=u)}9`NpN_xA?~%b9G9WaD8(myQd3>@?lfO1M3uLUM@MrxJ-5% z-Aoo3{)vBLzkMxPu}M5|P;@_DqpaJlI5qairC}e+p10VVeZL|cA3)9%Q$9(Y=JImx zjP!_8Tlj4}8{|KO{il17&h;hd9u`hV2tVjEe1DTk_+|JRh^(ItPs(xpMOb?aQ(#*Hp*!v;^s zv}Ma&;-{awoLbK<3gmS|3*~b|CCeWa{d$RREpo~BA2Hk|t@zfZegFMm;a9D4Y2u+I z@kQ#$k?z`Jh24Xf=5~X1_1FCF)OcD;_T(M>kW2jf8^Mcr)~*fpuQ8;qS>sYytZ>QV z%cNIcadpd;aYNMiDDl8}&HZc1fF~utEQW!vhpkFJYoKzz#5aO|0X{S~1TocPqS;|x z#5u~uhx}yL-PNK2{t)nt58un^haANQ+9$o^swhTNt)x34THq`4OpulabD{V9)ds#5 zm-)8%R*c1X+r~${o_t&x(c9W5hKoF9e)!nf#KhEzr)1~`$pvEF9pw*Tua(jFgohpy z?Z5Z5PusG^rTy}YOWV2ArR~_^(l&1nt>rJia0xSKy7-%Ja-{{+I6cL+6`xhn=M>5K z#KntU+P9+rrcEI@;AuzgrHThq7cFv0vp;gN(k;a#iyMfqZ#6V^{Tlq%t)3rJ#Y4#p7PwgPAiCf>$()-thwDTuley$}z!kAaWZWF#0G|h(Gz{A| z;EGr?`Kl)sW4Tp0u$)kmc!$^&{xrD5Ucz5tjolDfWANJDf`3u*FLa{S*UR)#^^ij-geT@7DoxfMU^V; zl99R4U${=&z1yYj+vn2u?{{f?_JrtQG@L)*#Sb6uqS6C-yqq~*!fUU&RM9_m{rb@J zd-sOmxkE>2$U2q`NE|!XMHRR-gJ+}S;#}Ob&wBpg8BhBl{H|RtZTogF4^o#db;<9( z>ur?K9R7@VfcFmK2W$iEVdhSZ0lxrV!1t&ah*A9o2ZH50F(7DV0?S@J$4`VqxqM>MaF2(N9XhX&N%oVF$41Z z#FMb?4&vV{_j5${#ZJwE*a9@XT=oagn_Xw{tm{W5%g`C2{I7DJ%KvVbe@_0D_zt$K z#mPNfI93@ayAFHL%WZHkd}lv#!eu{w+GRg`HgxGbG{hG3^cVeXPBGVB>yoEWcgW|o zpMUnWOFw@6@9?5ws%(oS$%>dpjWXb)W!opc^G=BV(lyAP^kc{Vgg7ckf?g+t)hkbk?DvM%Q@!k#~7D0SqyW#`X0PL5YjL*z^#^y|xj$rJDJHsV82#XJp zKRuv44D|ztrQ6BL<1-)|@`rsagEu_!0mNyEuUX$VX4)~E09){5`9s(b*tY96hwsI+)KoF_Rb?Ufm&6~T}Hf>zY)mOW?`|fiobLV>dA^rE?|IR;ZFI{|@f(ILl=H<6}{O zz;izTFW9s4@6TxslK)3HqeH(AU+D8EN;2zf}{Ix;?xMLNU7V!utD>eBGJq+`9@kEEa0V~XT^ zg5m?{i^P{+a>*Zj;IG8-<2_F#zWS<5UA@|+pNEI=0TM=ya19Cj`|o>xVC~2C zk>CIP^IkuA8HC=kF@$9ayp=d%f{W|h*Cmb_lBD(;5M9-mn< zlvns!bU&c{|2D;$pOvj{vfFSLi9_lS$Y-MO(Yr@Qhcn9mACxR1Ms7J^gGcV#XYP^h z1^@R?pN$7PX$@1e4fb5AMG|0DuuE5?% zCDtIHlX2i1CcN;1yP;A!H%Iz^y=eZ6;@rPV2fikJSZ)kki8v1Sav$LkpP{T|ztIOj z4EukVbcWNqKPwshv1CH6a0~z%6A!?a93q|DUowH30i(U$t-TAqn+%}_{ZZ*^{DBc_ zzj`32iT^?D=3V*s_%y`whzSzYVg1t=biOJnL3J5vu8Vv|^71yOD$&bPMr_dA3-b4%0rW_eT_6AGqkdg_ zI}ke#yIuFBx88E`0|tcb1pGwB^)ldP6B2Xu&j1e($&N%{;5%?3YvLbxz$J-?QWQtP zj`a4b_?0_yhjAszKaCR~Rui76k$GJB>nxd1>=)dS-|i;5Q!hZy3E!TWIKE*pK0wU{ zv6ykf&%N^VEw;oOBu9mhiJySYPA>UVUF;dLHEQ_2P}l4 zAdpYP?{6&l5k!FPtfRk-Rc-*p`aH7u54n zF)=P{!GbPYK7Q5`C0w-Z`^0hMJncN~!8@@be00_~zCCmh{*eO-qer`#Yp!uI4I21+ zR^@)s8~E+W3LneC&t!cA&&79QOj^UUBXEQ)&j>^8_hUR1h}k1gUC-6Y;EAC50rzqEyak6!lveK@}3Z3N;2_-VS*i4PE; zkz9t((B9?|UA}y1?MpWM7?Wt{ZTwTG{){ikwuhhie~O;VhE1=&{agwa^7dZJym{XL zBaVbG>ityu$5vqs(pNrSDL)ojkpUmJbJ6jvar_}-L;K|4AC-^iYXn6{;%wyqO;;EW z;0M~men58MAK+i@mtAm7G&mw!us?vf4L-vEtNcHG+8C%gBu9?Sp&!ftpOk$F{}JDL zM)bG(Y8$iRfID^y^haiq|KFn6$P(q>Usr4yo3WkfUm;BYAY6=mHEb^*-#edwkAJ3^ z4Qm)5E!&MZX5gRrj`#2J4@Dc+e1?5#Ha>TFKzaok5Z9we27J~sWgI>RcD|1P{@t$~L6Pr3 z{+pcw46s}#zsLh(^AO+oUVKUo4|eTyn)6+vf2-64cd4F_%9F=st6ke=YueO7dwl(b zkt1D3e23UxkZ$%_>zRB{>e3}Hn`DN~HM&@_kp7T;PA)0^k3TYp*BbVEL^>ia5Z}qF z@gz#8kOL++6WxaS0`thOX%3qB`80GElx}pUoGK@ zCtO_b-Y!`(0R74u`&)cZbU+8BYwab;FORw;*PmmNJrOJ4!N+%q4W9KwWP4a#YzRH!7>GnTr#ED@M=g!FgYAtUl+E zJxJ~t+swln&4YLOoGI9qvK5O8rn=@`Q+{?DO9crjP()VC)1fQ9DS@s>U_aRt=j~)G` zWWWKR|5u#8x@fO7n7&Jro zCcgZ#ug6NBHOt|9c{*YPLJRRjisVARkt1Ba#8{sz@2EaID!)&SK!b!BS5UP*$@um7 z3X;(oIij!)2kmmn|GP?Kxi)4Y6j}w?dr|HDy!7@d2wX z10GxANwqmk&%CVmsX;LM8ZGVnf4f`kkNx}KNiJdI<4bViqvD&gUVUw?`aWNK=!a)z z1CskjN8uM@>yTFf2gLkLmxbC0`^H6zs=iAx7p<*~+6!nTJKfiBQ2&8{FaE%;idF6{ z;hASb@d5ZmG)=^h!6#r$_4DO& zJyYY|P~ic8iM$u{M@CZL%>I+};g8?Zq0|CV<4&z5H3YWz9U7Q@omm@ZGi3I^3;B(+ z3$P#9w}y>Jefe71Xz&BECUTeTtD!9)AJCmXtwxQSFKT}95&Zs7wE;ij?_js~7M~kD z`iZH+ZiMQdM&CtaRZK3&$!E^{$gT;XD>R&`OSX|AN& zV$adtqBnLHc^GhpPc>5XxL>rau4keW5?r>cu5z)e@x;!LZQ0UA<;vv>>3_uPs3m1z z+DjTU>k!)pyS%@Cznc2c=ol9xpCazI+gzM-32~}NiYi>h$tS<9U_>0%~#t$Yd$m>z( zgI$7cxnH)#AKt$&>h~7F1K9ZNzq0XL8{C=0P{}iFd-!LU@*dPiuUCCHvVe8)P@WvF zayWnN`wiPx;LzuPS<8~EzU~7XAGwZf*5!RW`S--=SZC3dEB|dB)z;eSqIHTNGEunx zL^YXp{A-OL8bTBFU}wc=Vl>|%oZ+yN zWbh!ZarkAXaQR)?qV8wq{-~oNKEpl}@_V-D)Zk1eQo}`D7@0|2ZLeUd5hp%CjXkv) z)Y4fUoxumkaRW!%mxoHa{dQ#Nb>*WJoYPZ zxRL!8`VBi^u;^m&9?s~mHR$7NlBukHU;7bhTamvf|4)2R`PU%*Z4C8A|2sr~a*!XW zzJHC*57;KVnlo+SU-YRze*#+t*+ZNR|BSn6T3fY?Viwf$ zVITSRsGQvO z{)E<_lW$=8f9mehBmXbyALJMI=u_)K{{K|iH$5%8@{nW!I3#v&eM4`?&&6ljxmEV+ zpY>llH%2i&>VuIh>|I8WnjP%n!+4Kv)+{9dRr7n^*o^oA-XLd7{vP=c4@6&nxubq7 zDna`+Wv6pK1F{;s^+)+8zi91j*Tr5h)(*Z1W6f;*)GgcoLh2xQ%fF>Iml|!(f}u^~ z?;bup_u%}|ZS;+-z&|>me%VKVO1}9a;d6=PNU**?5`Wmo*h!)Kk5Fx}j}Hi*JTPqz zlzhTQ1Qx!ryYWzvo)`Mr=*K?QGwSCwW3Es{`G1XHe&u1U<1dxZ{BQm}d0q4u>jax+ zv95)ZW$+dABEE07rXL&YP;-dNo6jYRu0H=y{SPufa{cQ&v0c`FtZIFI9#%O4@&bwc z*6%)-Q1>d=Uh`%ktb*V$P4oK)NQbT|5vrco)fE|wC5x5EyQ2gOZfNH3=tnVEBN1} zOYsFven!Ia-S{c9|NXb$jDOfa>h~0}|34gCB39c|@c=uk0bM~2IzB(SYwDihN%|m0 zjh#46vX)#CJ|uecR{2o2|DHGyc>?O08|x}B`Qhugl{-r(zKdTKng5qR;B$M*;gX-h z2P7VYJxIKt`psC?WaMdolWO}_d#k-!YqVy6*4Vd77dM=!B8wjp-x?(R5)&X6 z{)F11j{SPgA?E|i&wsh-&-x9;Q@q_Lnc(X?sNGO5*5_~)6Y%?kgK zH_{t6a5p8zxo5Eb)qWS@Dad zBrM;V8#xU4A3KeCllR27h1SFy%)iYHp5L$^sPV)f0e9$0@&T+R=p9+#71<6li@vcj zh!3Er$Q#fOF~JU+A224*BjGRPyZNNF5&9hBDfauoYxIeaM-2e+0(im4@x`YmW6i#z z4fAiYAE+C`zVTz0jAd_($DP(-3&maX>-ne@+1Rr0V&tP!r^`i7pZHH2`@)D3?3JHL zTtG1xe#xgV+@kbk1u3(lD1d_i(S*sIjlR0`WE1{XP>i}`MIK<~Y%xm*7KD7Im( za(uy!}V?&ouuJ{gwO6$p4?G zKHKN-6^F$xpkB-O9iTsZDydOm?XQw=cu;=LarrmoG1;F%oPwN$&Dq9oc&saU;xm5# zzIf)S;Lpi7APFjyq=H#*vS^(f#>KO|Nc}s|4$tdamUE@YyCri>ge&QSog=+ zA0Qf#`#rAwKmG!=uso8%**q@v4jdPF;BNjQwjA;fJ|m`qUrYX<{r}X8a&DU0IYIev z@Yp@rEXd0rG}je^n{>Mtr;XN6Ue{8tS?w9W!R{wK0OPc^pa{PX7T z$iWahmJEoy;Ra8CVl>u2z6o{~^hb8?m+Znn4JX|H>Z%K8QnuCohW4i@xEk4iB%~KR*5u;S>HLMovw);Xc?ueiJq; z=O;h|gXf&K&>4}1eGQSFfduS@(%hb7-1a&0PW=gX3b8=Wru$9n=BUmn0w^!a~c1k`VkzZb3l79$`| zEPEhXzCl#MLZNv`kJ~)3>#3PWS0Tq(D~BY5kNETXiikII{8#_}PU#11AmZfSKW7bS z4Rg*dx&a%(`pfK2PM7>D`r7jM`1c1Drvw*v4qaxj{6=0K8A^PBGez-F&qxNGM3zX7 zJSIKLbN^(=pRaAB9cOHF7A`da_?X0{jW3X)(2aOD`~Nv-m$i@FG`U5Lh5RnI5PLqb zX)Q;D3?l}L9GoILkn5sOx`m$2-REwXAlr>P4Zp7fpN_p1^7Rw6{;AI={!3nvy*PiP zKl{55D@H6ov50VRh5ANjgHwyS;)9TTZTycsCUzoY=fY;dE{7)IjaWu2jUT=zM)HK(H@%09 z0awU*{CdLyF^}LG5WJ7#Rmlr*JT`w0e_kSOLkHqQz!Mw5U!o0Sk9M{a&+(ZY<2TZu zvt@hTEZu1|{kOEIP56pj3AzX#$EHPI6XS{8zh(W|9sLHakq_ud^c?uXzvg@lVr73B zn{ee}^W=5$Q?>s~Iefnd5T9OloWB$gB=5`qU}OSywSNB>`!J}*mM=)XT?%y~k`MJ2 zJG)gi0OW9?A-*0oKuEfA()%{s(yu9GCgG@IAf}J|aFLIZSv79>6|8_rfEL!P{4s|52SM zXLI;{6~uJ3w!JTBzCGW`|Kr=KHjF)7>%LwetZPbL9Au*~EdMJ#@n-r%shQKugv;`hf9g22bpVe({BfiI78DB|LD4 zj_?F=Qky?(J%qmyop{#~bqlOFe3737OC1HcWGx~qkh|axScB(o`ZY89{?l*t&;QX+ zv`;Jo+miZz&Y$NFA8@`T^3w7T^a-57GbU;i;8|=N-dnI+Hq9F40O4O^oyhx2;W)L2 zlW#^FKL5{JCjUMv~Ev|)20o==Sc{K~%N?eg!*!S9rwWlrcs_Gd)uSc4}%0FHc(yPn@A+l({% z_L76}ILz;3#plic%T7U7g=*vlFWcm>;scx$MlJ%o8@*~dsNftTadDyFtqo#R@F=kz z@>a(+Zu9S{2S5&>?<4C!44(BsYzn@mhG36;Blf+L|7R@#i!RP||3BwH82yRuQ2P;S z-;@7WZMEOOuXu29|GtfZ{C{`RpBVE@<^MJ)f4^7w!%hSL#7OOY&LDn_ew_D9y$|&l zn`GA>Q|=!B9y=Etpc|pT$vbPq;IWO#6XBoX-=9!?0RR4kaDlB)e1}|topEd9Hh5|$ zk^S_~`GD;0@MkcHkA4g9|3{aa3^sTh$N%;Iq2v}m%|Tt{f7y3V{{Nunk1R+31mnAm zo6G!L@>a-@mBJJA-=eig4xYLt&iIQw|HbORsJ|k%!`_O2%K!U)n4IG#8<6uK{N6C_ z?TXf3u_(!sDyq%uBl$>to*eFK$sXd9?7=5Shc4jECh%l36dc<4vH3Zl7#W6te^huU zwn7enpVlyPj2K1`J~)5QXGDI$@BaM_f@3c|zBx5K#7>O=40l0z)*ySt(LKoEbSE|B^m|%3J3|eC{K_M`cozfuoxaZ3PZ7V6pM3Qs?V0p@`=s;#mj4gS0?yt*_7mGzlA(LG4%dno(5?Suzp<`a-^ls3nlERr9EbiopKqt+ z7;_8eX*0tE_43RaIf{RNO0=WCA3eg_Ege4NEi+ht1INS{&^N$S-+xYfgxF^R|8lz#@fA)j+1&}8s|DW>iyDnDydkg6t zfuTCrZ<+G{KS_pf)4GEPUXlG_`|sglVtK@y*mKR9T(&;}`xF}x|J>*QMgL>M{f9;W z^zXqxelBPHVGpt|-*Vs7$Rp#4!&Bc+Z10S4_=Ws?&Pg!Zu~x|C0gp`@j1RES7Ta^T z=pQ=Yvy?w)6nq;z`>dJ@chq2TUO;evfYH*Py^wnl1|MdwYt)-yRR=*{^BwzlE#j+!%mAGwxMnuERnk{Ad+BK!5R^_V|78FCx84tNHd zu&*B(_>yEg`(~g6cqR`D&MZcP%|Q)<`F8LpwfNXf*kqHWlP(Y2&9ni}(m(Z#_%`TV z@~Fh>E`-+Sdxo(E<$I)^!#fSoPxyHF_vktBLw!5r`ET(7;@8AM;2Y{1pbaq$c%X~u zRZDw-IIA~Nd%v*rd@MkDe%3uc0%vcsCx~-g{27t>io^#ve}VHIi62Oh#Ecy2qLMgjLDu4(u3c~Vd5h&cJPmHioZ>q2E7$Lzuwxo*gInmj@$Tv z+E?gJpZKKYP>^%X0a{X1W45Wm!&3&&*mw^67+czE;)yNwlh58fCEn%H^HF*8hW3Bz zOwMfDhaasxP{N22KJMqwXJn5Texh`O&;46`fc^WD3n}7(Si$&tYb{&<;Fh`_)-3a2 z4A=te7}~JU*uMDp_~)!k=1%I!y(|C^ z@c4I(mFIZx#7@B;kbb95j~EF&K`z5|rQy%uv5kOd-4ojZp1cq70rp&g7vhwrD|gNhGes}i$=pY1GI>(}POZJo#V)}&p(c{}0Pi-#*CAd^ zjOTp$f7&5-g{QN8}w##D;?Tf9sbqa}Gzw`47~GLVK$Z4b}-OUgYD1 z${lcCjGwRQZ*7r>f&T1ITdgr4=Inj>28VroC3KESFVWwgH+&f$IlG&D6}-Mhwk5Uw zyr1v5d?oy5P53RC|39Yq zfboFUnOeU#j|;uiFR;N2SZW)Pnegf#nlt-W@lW;%f7puH0H(i?{|0Zm0Q9+)hUQ^02F(k<6B`e^-p2-1!{F=t z6{p-P{68oCX6ILAHh$)HLbjKZf0P-l{f2&re#8e3NM;aQ zBF1<~dH{Rg;-mI_E!uP6Uc-4wnpac*)$=ELF#;#1?NpfkxA8$2~|tU+?4oF_}(o%eRNmhG3XOJ^6a z^WCuD{22h8tw?>p>OK;N4|fTVKOU+9+PgQD8wkpNJ}YOCD&9zv{hwDjs3dvIo-AaN z>14)&{qJcY8Nk`5#OSAsAFXbRu`*}$1vvrahQ$Yn(P0CU(;!I(iyg&Gw#C7iG`j%Z?PE5hM9Ryhz=-&5wEW4jkkheh#vo z{h0VYrWcU|#JPqEj}OZpZkjEt%X8xmE@7@}zQ5EN0Gz3)Sf9UskdM#Vii-761Dx>G zQ!Yh*9_u_~e`xp&fHc{GIX{~1uF9Xsby5!aUilQ*mFQ&7t~dT94uvm+EW>Xat+@~n z0`K6LeJR9{@d>eMsZXOW%ihfa4Ld6a0DiE0UYA`2je!U6#B|^>=FhqL*lf_ubR%+z z^E1(f*bMK=7rja}Hr~Mpq0WoA8M%LSK6XFymuHYeErn0c`oeZyA-!{-YIRKZ8l9}Y z|8}?MD@wmn!vUKg9l!^~C;(x6}))58BBl zo6^fEo&Os5=3Alszt#5R<5A~LEdX^O#CVkZ<@{F8U-k8%Gx!+T>F5gL1HM*9xUm`(dp@#%Vu9Eg;0@ekD>4RX08d4pA7C{#)}GPQzF)}Q zXb8UWMaeT_Ut*6U=g8?1&!w)%Vz|M6jPJl5aVUIS+Tr57DC#YVvyq$o3%uyh_+qcS zPU~Lp{P{t3Kg4q+-@P42eLp@vzCQdQyPn!G&T5Wk-@obxVsE?6#dq%PqN-Q-`}c2> z9wGlv?FadP)+oHlT46m~4NWi)VfGa=pE?_C67Y_U#jeFxfEL*9$aBVQbLO+@T8kZ9 ze8BSm_;tt`_QX*m>0z{nxpNsVkt^gbGi+q_jc*MeS&PK~k*z#$Fu+4UtH-c5FZ6D- zhp&l+L3{kWJ+g=JO?T^#twOv3dB$Ej8#Ay54-Sc8qF1RO*&*9-k8&RCly@O6#hwYy z(y$n(hYiy|?)KaL`li0a(^_Xf`1*eH@8#F=-JkDA{$DmBXG2ELv8L8e7vX29`r+MP zpX+SFpVU9OOK1Qe+$KE$oQ<8k;S&7~k5KpH^Z$xZ?2}!``~9%@n48(>!8QyY{|NvBLANF0`URr)8R$rnboS%ui-xu7Z>{7 z;CcT8>zsM|eXFvG+~ws%`~Rh5;0x@v^X321o0k8lHXXbAtl|TE#Y6Z@tVQC3X5adL zjsE2SIsc#f53P3}`;YYRE&s3l0B7-0`(tyowyu%ie7zJH^Kb!ufyV1JI8c@A=;U zfDHlvz-Q#oL;3%5-bdhkKx!C}L8e2Db~cWGbGJ5-XY-2Y@qQhC31`2P`@_EdO)`M< zCaG`E?0i?7Kj%IB*aq}he1P}bkwa(SJ2n70M6)3#t{gOp-V$NpGddVf87pm#ZEzW+S29bBtt<}2ONB&>q|3!0R{acR0_aCOc$$#v8 z>{jSU{-4~horS+&ZDAX6#^!@%NByB>zueXNd3U^Eu`I|IoEuyi4su zQ13M|_X-N_dw9@qty6gT%F{eKS8Q1RJjZELqCuaee-uv-`vO{*3zW@OSb& z><8d1XYxS_BS*Rf)q}zhF^c!4YtKlR)Oa^qH1y}M2;aX*e(zI!VuR?1ePe4Ua_oF3 z#!ZY1n+^XO|NbQYo&0n5S|J>*b#_VzO_5GF-2*OIYv?k3 zYiMd~fcjkgHDYnBVd6Wd!u~z--S9}Biy8=Q25@1105~E>N4*?t;0*NF`uSS>9E1Kn zb}(o70}oGFO(1?W@d0c{504BGJoPKsF800$d@XQKo4l{l?CKybZLAk^55ln*>wEDo zG86x{uY60(Nst5P92e{)bP;O;c}pFL@gI7O{I;*1mFyp^=WTq%Fgarb{~CXW_vPH7 zccxrbD8Eb5xu40h1E}Zrwf*6Jo!EZR+MoF$AJ3n|OT8Fzf|WYso%eIHSLA~aT#ViU zP@-O4H$;0RW)&~sdGTrSuGL4NyNN}R2gD~FCt5R>&Z=FrF%sipuQPfWI%2z44g22U zl6@WK-;=|q4e|ySJA^jfMJw!H&hBE5!PTOb(SbS;aE7h`o_9#HcieO%GLrfO-UCAY z?>zZWoEvKJ@GN=&n+o5Q{TkRE?8D%hAT15%Lhg}p_yoq+z=I#`7yJ`!RPe)Er?ws0 z8jOGOJUkPW_xRq#Ul}X!jbQvQiUypO*F}C?b@4#Fe7hvY`~3UB@cmWyO|4H{uU9<-Y=CnB*dM??5o!h$|H=B~Q!Xk#-X&@bW^38}(f`nn956mMF=*=3h!Ic& zV(XCS8L!3D{)7+Ni1>K;<=Bd}!CHWZcE%;oqo*yGWAMZTSv%m6JRq{38jg^CoIQhw zcphC#|3SL2wy+U^2Nu5!zXH1pT5#3|u(lSh-;24^Z?I3(`P3RQR&v#>3-Zs%2gZSJ zBi3d*BG|vdQ}4t)nKy9()(0_f_8kzbYnBx2^5_gFV)wE5_VVjvZ@txVmOt;_P0`t! zyr;pR`#?;9yg!%Zh2JZ}Igz}RMR@|=@8{<%d20SS`Io_pVX)?)9l0#Vk8cg`kY#`F z5BR%(j{bso*h_$oXZe4_0eo%eLj~gthD+9ytsmfhd_Z{Q&UfNwmOnCmWOSnq_=#91 zF&3UDE`XiFg>Qj<$(|y^xAkjnTeVn$T!%f3tO9<7I_u3&pm8-4#vyy2E1eWd*1tP z@d4~Ta6lcH`G+=tgC}mzT!ZlYrQfL^z_){sh+A1KJrW-MKn@<>h4wpS+Yn!%HW~kP zlXL~OId+DK^&5%Li}`N!M=o0apRxXqZzTWzxa?Bw6!!G9w!ty&NA^uS)JEWg!K=I% zYn$xyW#RlkeBDmI6=x_?%WeJAR!qZ&E{XU4Xl*0&{r=y~&Iq&ozv9C92Y#Lr`G0cM z#ADZJ%jfJ*mrO)=r`i=(D~2&f7y)v|L`?-uK8!yj^Tp%kimQZ zKDWNUMtII$P26*Rf$@gO{2=$(EU zbMOL|xEeB(Sd`y;F5i^*1CskD#zu_SY#8KMBs}&j`U5`a+;G4CwGM&f{m`xT|Kj0s z;?rj>Qp9CZZXjCcyYlWH>ihiufA)t&=KlCDpMks(X9LCQ9C<&FK>nYzN6D)&hE3|9 z7}aU*oj|<)i$^Eyq}NQKXsozHXNXTM*biAb6&94f0Xux_`apLYz)X%@Qdw){3L(NdrXMa z5o@K6H<;@-IJ;vDBd6dKWG(oH|MBnlDn5Yz5AN|bxZs@{IOK=VpA#Pl`}e=eM7TtN=M-Z+i7XHgye9ns%s4gPHI6wdbJ z3;^Z($ot~=C&>QeJz(Ski4p&8j|lw089>@6m>^k^Q)4YHTe-Y0i#sqjYN)WEv732+ z((jT1zbi)kiROfDZsW&}C0@XJ+r&I=4O2hxvf#0Q(HWe7a)$Vr{QIDfh93Yt_@idt z)&)6ed}Cj~2R!r>{7*Wkn0LurKlo1Md-3thYs{9ngonuykzb(R%b(Gx{UNSeNiSD3 zv%hUl|8zInb1pse;~f?FNANVhY7jU0udi#ZAVa~!BYFPx@6lbv39++SPu$7-P|IL_ z;KPg&4i*XLlL~83rs{r*UVoj7lii+5ZNKa{@6S=wjgPOIZ)$>}GEEu#jII1#x5 z#R}4}2^KAKR}?GkIw=R-S3U)Gg~Xl7>DwL+Vm#O)hY*yFuTF<{7>`_{?DGLee5&*2z)%&2xCJ= zg9FY-HaPGEuce9~?KgOn_$Ox;U}K>x@RPv6uL04!0eKH2pS>-h*pRpXCHHv;{FS9kxXy{$+yL?HC|&F?fS% z0>9U1bTvGH?z8wtaL(p$Qu{!i0Q+q52k>i&O_2X*9Z_3tJnG@Igm6!NZ>r99$%y&j z+gt7*-=4kystdsP=iQ2N_uS)S0AXaSYSiv2jus7B-Y0{ygVOi+tZ$n!`i!$yTPDupc642bUWu^?UQa| zA3uBm9nsa)_0cXk1J>ZVTkeEhF=yUWThAHb%pV$Hdz*da;boiCR-E!VUa!k;%gFyL z*XPdwpawt}@}B>(PdHI=V)B2H^JDFh{~sbg<$b%KN++*WjWIZcmW;vTD>ioSMt^h^ zYnOEo-GA1Z&zxhAtxt@FSYPjee`swOEr{pCBk&5e|rn+VskfmYyj4HC_bS4G5Z5#o8v2Et051O;if|(;W=A_y4X)|CDfyFSSnVkN1-jpWt2E)GbrL%vf#Q+)WmPf7X}x@AW+I zzQDgfCHn2x9QYj@;(YMf>DYTbhi^dc5dZ!R=Q~P{qDROR(Pyv?>p!$V;1aJp*dO5I z1M=_B35S1Z4)`m`P|HyucWfR;N7}vE%lgNrJ*QX*HYNH0bDH-#@xW2V>AsWvV(iBI zne~BP&-sqn)Wipls-2UX|3S5}OmW`G`pYP@TXdEKu{~-z{aIeN=IxG+ug}E(lC-}! zwtIJ<8{l2vB6wflEjd7(c811e`{Oc$=QnC-EWW^g z4r)i7;Qx>u#b2Pd_qy6cQw{fDVtZlQV*}s= zvIiWx^M3B+nKS)wystf3-?OPcyj=ZyZkTBJdAVXf|4&?p8n8LiKfxMn>{#?Ix%Xgv zfZwni$!QQ%CqBp-82IEzAa;$fF9-cBBf){)aVq_kk_<-p5qx1>;pX@n!jaUTm z#GK5ACO_`u16o5~hKL5|1ix9b4BNwE%iP)Lhs{D8RtNlVdBEUU-%rTb7V!}GK!rvopTZ?Cma&40Y!smeL9J~pH?o;fqfpAj$F!P#)^6UnAMLzSBeeI zOI81g-ADdDcs3(G8gT)9TIRtx7!x#M4#cn@7d&S)Q#&|U>z4ESY<|>%U}Ip zf1BzD%r3*vA1FIvg<{*-9>ja8*Ee|fnNTMWJU%{Sz&En^Ko04}-m>$Fv+Wf;b_eg) zvAhy%4mksk@ioW?lAF0g>ybW;me${e-h*%n;)4?6ON%Gb20j9LI`eI@hp8FH<{>X? zwbeET;?UTY)<1E@J2Wr9_eU^qYTpCzSQw(~HpPCc)VabX%MbKt06~8)*#g*xtb5M= zfX?1eq*jpJKlwm?_UAw>TI7fwX3_aTQL(Wuzs75OHf#*+VW8dve;&Ny^WfW(lcxqG zsNblGWj)*4qz&Mqo8bUk9lwk@u}1_PSzqu2@WC1gWG3fM;NwNc2L>pP7Q{EcaxuZ% z+NND(2JcuT2MzwQHL$s{yV%cS{%w$!Hl7Q)BcFov1;*?H_N-8oLZA32#0so79-lcF z9|-nkV`1H(Ly0lb2Kz&Z7rZ2VJfu0b)B6>3NtQ+H>~_w2NY>u3B-Qi8O1H;z?kDGi zs?NjLeT3iP>2v>lCRRl5m%5-?GhMXy1NbqB=S=1z=iy&y<$}VUrQ(!smkr$Z_~N zYu>>*@EM(j{gvV03zj$s>l2@kc5Q!v;Vjq&yg?iccxc8sS>O>F1^qZLg7 z_jYm?xW70bkeCs&fc(Gq|NA*emf9SUPpm!G{0iZ2i*zdQ2SZO`v%(YTHpU;Ezxns* zTI#dmTjKBJu!#>~tK&D5mxVsIehddj4{QzOJ-iZxCq96^3H>-9!t8s4xA7CVM&B|{ zXwSQi$UE(korvE?P6(dHhA|pkD80}3oY4;5=+B$g7}4oRWY?S{J|O$f-VaDV2OMSA zH|-E}M_y8E!TTkT$v6I0xg&f-=7fJ(gBWvG#Z=M7VSOC?pZ|o`{twz8#Q9M8i0B6M z55jk92L1cn6-VHVSU;z*kI85Jd)7E|llM;?Q{E2SjQ6HvYmt{EKWB3`oEZM8aYW9+ z>%0#R|K8#Q#7N+4;yWhqtsR38=Kt9ra7=b3xjW7W>>VLJm70U^t;&s#AB1F|)17CQHv_|W-$M0h~`U1P~H1PrX=e#rTpx~K< z#h1WYBs}NmTm68y?LE9=EW!akH!=tvYBoqDJoX{-9bG~GKNKHO-dFV>`0Lc$BS)~? zY!2Kn=AzH@Jx`r6F%;s#KKHFYi4n0+h4(oi`z%kHSsVCE>?cNcad!EM@}d3X2jrhE z6Fl`{LHj8qKA?KQ6y*hp|3;qsPVPS=|F6%)iPLv%cUkm)UO$F#j)BkEQ{?raGx$Ft zoO8zIS*_#UlH>4i^ zjz|s?pN`yPYp`}F{-06*qj!F=H-z&6L;3$AZi?o>v$kdp?n3TC+T#O}hh#mPKBA4D zTEo248T{cN5+C54;8&#=EkDU~*s;hf+OhY>^E);qehoSkxl8>B?-63Zp6M-~Lk3bq zP)Jv@zQ<|LpQk;(VVLGd`waS1FD`!}UiHFB!Zki8ZCK8UcFFUir-)CmUi|(X(GUI$ z`uB{P`7kCsZx?v*L9Hw63?4TA3HkRa8F+_RsCU6vGrtaa#)J$&UJ@fCzUp*-|0dZ& zoE>RC9x{NsgNlMD?qV{?;sex$vp>bdb6#V$Qa;9Qb?!l0((iw}?0Me(z}|jvgl&$G zk4`hcf_B;{28F&RzJq`IvSbpqP5ci#0UH*d8eN7=M=l_HZ48_(f&W9z)B(|eGpovk z?LOvDop4{l^j9pmhpv|KF|J&>G8yrK9EuU;kp9mhdG9YihvP=6yLP*()vLJw2!=c$ zZO|6F-)h;Z!^H3WMPug-6Z9!{DK_);aHGbG%c)FUj{knR%Ww=iI&5UVD{yy}h7YV3-W?(Af3r%vmdVoE?{}h_9hH zUVq_0HY69nDEI9ly)NFJZ(QMhG?cB_`|&G$D8NR=7k~l!1<$MbVGO5a4J)_&&87Rb z_u!OFOrC+`$Y}PNE!;j+h-fhTSo3o)}%i^CC;I z|Fix3*aLmnIWlHB9ns{{sktVm$)1zN=r;Ou-~-ZcYrS{L^ZghBIMcp~*Y`YrhaZi2 zgHineIPiSmhr-^gHz6hgJ+S`d6*?BOD;c!bTb>`azE%bv>e|iSd(YMWA07Pz9)wIw zmLS*RY1yvfJhrd0UDf;g&s#h3f6fzMSTD>DIjq0QJAAE_00W+SV!{;~Q z937Q4Ie2OGIV+ZT3!ne|ZrSPoIfxS?`^P72L9T7F{!Dl1SY-UP^$fV>Yi1Aa2Yl3z zU$6JqxAR4hMIVI6qT4W!x#9zA&FWd-XcoO7yjjmX+od0%BbtprP5b_{*1-8u2aSA> zNAYfZVGsBdxL)z=qwn|k=(T?TtNLAQ4{ytnz|M;{vir-OEpIkBfD4@Cvj6w_`|2Bf z@J$3mzsPg))18}d{2rK~uPhy5jkmt_!MD*I;U4+H#O{AH-}VrVI5v5G4~Varw#L2Q z%*?Wij#;G}br$uKk2e9$L(R5c;f5G$h?!pOtJMi~qzyEn?^7)bR zD?WhSPlr+S9ep0&$3x!ueC&?lkxD;c4V;0ZL$l8h$Inj?z9%D-iGQ9wz?aew*c0#w zH^KkL;H>MT_OQlvbH3}@mBA(KR`eLgdsX=2Cg10q?V64We>>{mU(ci4iM$& zt05&0&H2U8U68upSA@SL+u^stl^P`VTz%JA#8S#}K)wgJSI6$hx0fy39KaA5Fa6Hw z^Xv*}U$Y;kz50NjZ~5i&w>>3)R7_f}UA-S~3jW{@zLi%+u4?*$$cK16JSTiud_X;4 zZ^PV$qpL(8t51rFa&X7ORFXVap z0kQ^rwD`wrKl*&Xen5*o&e-ww?Ehp%djP(R2G{exjp>$tYCLMkUC;iXvEE?)!&`d4 z82<0)-F)Xuw>8(h=(qR{!y#x^b55&_Xr>N@$5l^zl;IzAs@fK zeb}hv(eiHmzPx7qz6*}^e{%MKPPW@)>$VsD+zaMPk4H`=XYe;8TUs0agMqh(Pov+U zn^ni*Ss5ez;65FaIa@o=vq!57TE5lJ1zQ^$zy}BIcv;3+a7ykpe|aj%Wj^HOorgM< z+RK{n+J5(++cNy1oCSMkto6JzW8L6EG8I18S;6zr50vdsd$r8&n02~M*212Zw#mPpY8v~AE57a zBW!qNV(+$&U{F5MK8@->>o@*@eYNC!a=8zBElz;!ReH)AbH9(}u_eM8bX%So=r{&; zcW^+yE&Kmm&*QQA{n+om{lD)+QT3&2&FlU81C!1l*u!Vr1GZE$yFTbz;Ej6bFZnJw zC|GcY;cL9Dcara0?0ml2gT%h_{gfl!dp$=!^{KUZX5ia8(TRwE7QfDp>UlWcx)z@9 zKVNG>J}`G{e`e%?p9a6O{>VPzNMeqJ2()Yvv+tK{{7_pYr-Gl)r}tvJ~4ab zUDmGuPOvKn7&xI@yd?HAb+gG9Y^VC9FGN>8*B^V0LHxP3gLi(Db-O0|0ncBSb!3yq zyNdhizqj8P|7AGSIOVOlIBeC+Y610RqZ z!+b?4~OStI?|nen^&u>X7_9hi1W7{Q2o8ntT!-lP%c#!%xNIS0A!pMAA7CeJ%WGLR0Av5 zc|QBr{)hKW7*cYZ%>6|sr+ygenC zS#NOLp3m4@yun`E&f@O=-q+Zx54qNxP9iWjcs}PxzQWsV*PS%S*{$cRPqo_HnaO+G z^LytE-(k0$wWcn!Qf%x@#(b8;kxYIb$RZFee-+D;5e#h=tfz2%fW1gw;&OSffM>18*3)-HKZY%J6z4?Qoz|ZXhn^_P@T|+~-ciq!vELCGxX$x?51#*h;P!>XbEA*ZweMeZ zPkzs9nqCS1-mcNlH-xs-J689+zT_jg9NxX%;CVS3PYz#Id{^}|I-lwnAMqP{q1&a8 z+h#8V`)ssgu|2b@=j%Ei|CjOiY0qc;Z~(ksczacQSFlMJ@}uxiEk~#K2afPg`vx|= zzuJwC|1bT!#;>0pg6HAdyN0IKx>=uEqq*MIe}1d16`c!TkiJcLbGLMLtXRT&v)0qKKk3Z=NjYM=C5DX^ZKm48GYyI z-+0;4Yu0^jpPy^|t6G=Q_xO9R=e>KbbzR%%TfgaJuJ->G*NoLXZqB;*$MKgwUvO|s z-`{_JZP&d&{{JVQAMU{|8GnB+>wf?Dott%Qy>6}7!N58gSO){^VBmiU2J+f<|JJR* zx)oTr0_#>_-3qK*f&Wb_uu~>`a6VtoXT5n_<^TLUao)TY6NAs-Li_)}O_!9nt$WwH zHCP7&>tJAwFi?6|-}Ihq(tVD$Uz2^MwNJmk>-U=QlRk~3+WTJJGdH(=&2w%0zq##K zH`e~WRju`^=DVuv{XYA@SJ!^7dvjf@{^q(j*R|EPcW+hC+}!J{TDyAxn!f9KzRY}7 zgAcMngLJB+{>SPw0-@(Pwb*EjlaA# z;;+FMT|c#k{l3@ccl9gwLL92x4HX|PR>hqA{a1T_U}~GmccVT3K>o&Z_iJD6Y7G81 zPd;+hp1&Hu+0pj(teo3t4cqfe?bLB5r z?fISa`|tb6R(p9Xjh!#B_vl}He#Poy7^`{KT;-Hh+n67=*gWfLf91%jT%-N=-YGs> z`^vA+m()ATZ%zAJqm}WI5F^3oOndJT8w)0!n;K8G=Z7J#!1%Q{2fyusdY09GZPvWs zruyfbtk3h~CnqQHW$~X=3ySZGoR-yptq)&LzUlI8T#_6w{Jr@`O8U6L)J8UiF znm#}NF+WTG^?y&_d|vM#-|gzZ_KUB$*a7hQi})j}=Vtx+nDf;gZO>oBJ!}5+)TI4I zd}#PH8K-r7`q@d?Ii&g%XCK64f~%CFR!(f*cv zs(-$z;_B3r=EEkx^hH@)W30GFXQlib;2Cq3YwW^|{bz}1m-~tjy4o_v!tbKmi;rvm z(HZ}bvp#1e{@&l>8Y(YhzrA=J{?7c-zn8uGPTGqJ5?fPo-uf=z5b@34t<4!}|NV@I zzpGdlF<&*FI`877#C4d%C7G*S!eX+(VEOs$yV{GB5kKm@^T%wltMM!4S1X^3{>z7?U@QpBVqMejbr}mLHTjs>+?> zTYQuFx{CR&w!WQreOXg}$3Al1s&Uz`xm3@1rx+vqsjaaL;%-*lB)4<5w?6#w`Rv1= zm-3N~&-16ZUfJRnt6l%wSk+qqr`Onn_-X!Ua(_EZ{dV=cV7vZa)pzZcIIrga$!|A) zlyA%2D=v;dml*WJ;)h!CiemL%ld}gW^W7JBSoxUbDm)_Vq2`}BO7C`##Q47>>u&Gl z@u|GkcW7~g%Njiv%cQ-UBl6mb}hY#V%qw(Bk|>r2p_#;)?9lqA^zN0@LWFlqVjz# z_||rHpTb4`HgZ>?gLol42%0aBM6HR+In{4(o$yR>5*`PALl?y^6(7}a56k6&k_-(F0%*jRN=we^hg$z4)squ<^hh=D~H%)$7@1>$8Y-$=hbm@qfvv5w{- zE(0Bu=d0h=Z}3rZ`DioV+H?4#!reFL3}_36if4BI@MvP87&LMOKIiQ4Q=iU$ygF;PclOel7Y;vu-*eeygPkvjew?{mc$UyvImyLB?ms*O z=$U7<-#2}TWrXv75IXz4&{_K>UijWQN80q;?-kg7W7=E)ABBgyAT&*!5BPX|&S@J@ zZ@%CGEZZYBel8Cl7Q2DxulOx+TI(avmAn}CR=(P+#EgY65_5&dRlBu01KJpS?SZl3 zZNbb%Sw}HJV&;uq?lnBbVEi}oIS1uj4r1sM1GxKk-M=SCkoi16cy_n+*VbqG@@_%$ z3;BK5h4Z@Cq%S$RzO>U;-M=QUkeX&MNG#}WhwbO5?Sed`{p~XMS7mR|vIgjpNmbuEIC|APILmMhT zk@YWJ;Y_3X_#*W#TkJ)A?!~Lv^Md^~t^ca-qX*zw{F7WUa$Ufmc!7$AvM%*Ohvdz- z2i|{5&iRW%lO7Q{f978I>XyFY4K0uRlzjfj9@}lS?;X0smW_3<*z{Hn=B<^Qk&jB< zfDP_)K)2+?*K|{<1u=DM>cqeDRo(Kt-lcouvhl=}59+>Ye`In2J~r()x#Pawq7zQ& zrqql``=zNdI(47>bO#3}#@F&*WG%&EeK%vWp2g>& zb81WeZO*>4t6$f|Ld(~tR@URP_FEnP^lto&GrF1NQD2r?>hh^COFh1^fBjsy-NPOl z-f^aT+2$K{N98#+8+Lf~BfIhB+Mbb%zuKop+gNh7ZvMD~yF-%8?8RyS4{86n)a2Xw z!4K@lQpaJoy?nku{9!kK+BdqD&p5n0WTO?`E4N6kyYQEv%N|rs3GkvWFP@?30Y1up z(FLf%`J>>ts_g^b9~fR;z7BkcwZj*I1GyMl{7&N5#C)s`?y0p$N9drOJ9`g))sz#{ zZ%x%@@?NyRa*~ik(J^vA9zkxv%9Vj{y-V=-zIk^2!14I$-|m*3b=Dxi{rTs&`i9eI zpWX7FFG>CD<-6?M?Y($Gw_oZUZM4Vk-Pjkt(DtY0M6dStB6-r6e*6>NbaLSCxnR9+ zzas^bFJHDGyf9|~VT7B78OI|*C`2~|# zQhmbtsY_7p7bL&om^ww(e!bK%nEvKB250KR6~nbn{a~K>MXf z9MS5FHrUU7^@Ljgat5c~oO3pw9K#Dzi*&$8rT)p-(%_5@8gKlQ%=MzsHM$(KSk+O#dU!TD%>(`j2wUN_Ec){$j3igv&(u;<-9CD_~35du!h6pM?Gqg!#ig~y@s3Q?oa++HC>iwPv?zC zjtxAR%QpGEID9@i?%b^B@548W@ueTXkuSZGc8brn{_ukQg?K?Z#_=WpH}pT^m+615 ziSCE~=i2aH>NC;>E*Qdmf8U%5^wl1~J#=02q`-%jC#G_oFHB8aG<3%Lt9w+Ru4}kj z-DB(7YMup8EPm3Hx`}tbv*D}RnpvJn`p{JYfvQsyn+CuPggXdcR;D?D*PU)7W#$2mG68>d6pNS8Apj(F~njr#>~P{eveBomTrx4LCL7r&2fCxq(+EQzJ;NDC<2P zURFJrRud-lb@Ia>ZuJ7EzVel}2Q$eT?%B3i>8sV1!Vjgc)HGfod4-o|4>q{Zy}Ji5 zp5JPV-pJ=HZu}%$2HlCgp|#HNJ3H7j!{_WXTmvv?O|+#S^I`uiKBT|CtAc%PiWc--w`wq zF`VcBiAOo z1Dhlrd-0{(R(tgctp5+Q{y&YJ|HbHY@T89lUEXRar>wVVz)vj+Y^y0YC!d2i4X&7o z4q?4vouQ@SQK!gdbMZM@Q}Trxrt>EUwIG)~{_$k^hCCO>ze(k~N zbM<$vz3&5}tD*Zr%S&I62Y}DjWH~eEiVa9^R?o{TPG`g>TeYLfkMI-TT0V})N1wCx zK@VxQQ^>kgUrQ~;d{4an?cEqYhu#K!7GIRLfrBPPCs#xlv1887&e2V5wCN_@Sa?Z% zW?Ro8Pt^FGtmWjd&+k?oaOZCOj7z@Cjb_3Nr}iuS)9OA}|7v>V*{ST=iiiD8w|m;} zA3b=TXEp}BKE1OVF8CZdG|iV@MXe(C?6R%li_|ZZtE_U$(zzFW*80|Z_rL2N{J}p5 zFKn&Z8`x`0mi5i9cHi(h-lq>^0N--|TI-i&UrHy9Z~g1=pZ5sP-)NuPN1qe^6WzqK z&?{t3;QopCyl1cnculp@gCoG_WN`D24}VzqfJL#Vg?2nHpNFLO#V+@{M>i2&(oA#= z1=HG31($65lqYxhPc4mu)7IxfIdi-0wMRD*o^>Ylr0S}*_SuVVjybw}WOR2&2S0)r zIQ2o{`^*jR_lUq9e|CyzWn%M&TRTK?T?La@^7P`t#w@!?X9!nS-v68 z-C6mRoerN<``F(%HbHhS?as&tP5wZ}qee;DA*=nO$W(NZt+pio1`k4)6S_Mcotbm6 zDEglzPmhlDHLvLw9dk^#!Jd0`2c>4^GxC0RWqDw&)01+RR&Kd@w=jGTerGE5bxCyE zGk4gh)iI%qW@~ds*$@ty%-P#~({8~tp3zN(M^)!?EHq;3ukPMGB0L%W)=9ya?Dgb# z{8~TP>g*h{zU17>QO8$EE_1M_c3rjWf7c%LuZ{k$HgAj_oi2kv&!s~?$2-V}bq3J# zqUU6EXNCU>o6-+rXEA;@{K8GM`k!~dd!R$k+P4~B_?+MiIEQ|%=@U}Z(b#G{y9DPv zIXY&1^~bi~yzx=^iMQsne{fN?t@d!vky&r@;AcbgzmodE))fA`cdxEQ!Q)nG|AO>w z?N3WvIv{#Sd`#7OgAMeJhs(0J%)tdH*+m+PzhR6Dt^ex1D3 zP5+aeV^_!S!2gQ=?MD62jeHI{4}aYBZ;{*2itH#q7#wsH{m+uv+26Gq{ZI4*li?}V zVKvVA(M$T?GkWF2v;KI&Gs4IIJUE#ALB~q3jmM-HY5Lpz-en>-oUA9j`SZZT@4`3A z8;LJ}Al%(=pSo?^M}G_7kZpdQ_G+Bb|5(rR|LOBN*5BCxlLJ0y$CeWdU-IJM9Ah?? zrt`{ot?TO6zCDw@^8L8bT>2ljHu|4yqK{Hvo)1UCK))}xAovHo@Y%zY(*N+mDgVim zYZgWRpP~N=kKg#eqJzQPWFh*TMF$-;(CIw&sU1FN#pauJ&j>DlSN7jI`(^e(-EOwb zqVxUns5=4g@L6ErRiopwoMXNbb$Bt-k!y=;tOP*Qz}}`RPwLJiRbFxxMz^uX|s{^rOgp zY}?-mp15=PGjrtEz}CaoR(zTqu=MxVQ|`-iVxKSHPr3j!Ywy5))vabv;bX_|kiLsv z`H@3DhiuQsM$X~lDH^Yz{cr8V7hRe&RyJWYkFJ3HNgr2qwZFdoz3Kn%w|P*WS6fTI zzw%#sNZ`=fbN0;-+|)Y5O?Wf@bCv5JJkaHlV~)-D<3agN+hK?8xZjomZl5{3hwoCS z;ON}nYv>;UcN~$wjmZZ+ziY;*Jzh@zHMs-#AM!b5FuFwkhR(P%SGIa~8~Nh-pxK!D&Yt=P)vmtbLSyBBr7d3-@}u1Nd}^y*eZ#f%3}B5eqZ_)gE$LhX|<`kd9U(dSZbI>%og};)uWe2TuiBG8ZWHtU!KMWl^ zE9d{S$*0IR{h08jTLc$*ckMM@8CY*NUOG-P7`Zq6QL`aN{+eXBivFSLXY%Z>!7<)V zKSpn?&NaG>FDyHtvDA2s(K)0G{Bhd;a>(b6_VD|2}JB z{QddDNpDO4>Z<%Q?fLS`;|d3=%XV|{kiP8|8txtb1`GD|qOAK3so8{1frrucul5fQ z9d`!l-+s2o_T87_H^Uc#{%7lv^$P zME$C(gXiI6^?$@9)cVwTZk_da9`OlRr0or%YjW&bPkQx1`y1zr&S?*ZuS);?c}oAo z&qVuzQNP*6oJH-g487++OaCK>>=y$gHI9Ng&&>64f37xsC-EQnEVZ)a2LELGg>&J; z(Z0Z&v#xFdpEkO4GSU50vvVf+XF+txOOJR~!#!+Rlkx3=b4r#iyH%4_!<#O7)li=^ zga>vGxCS1SQ~L721D&HW72n$*6Wde`0^=6Yx3L zg)cfiFgO?fv1TvKTCj^%do_{N26;tjfWGSt^xxC}-CuXHDBy^1OW9M@t!I~3^W;Yv z6W^G^o&4|iPg}K#%U2rD;LMX9$Uld~{<6cp@7XPVe{g;Dmuw{D(D66FxnmQYjxD6= zo{KM{*Fm4r>iAS8uDshl?dN8^2$%|@u!9#RV=41@UqSivybHewa73}5soL`5} zaZa_z=a6^tF6v*nhKAuY#6M_{&q1TzqYL1l%^$q#IXeUNF!E0~{ZI1ef{%&~>#wgq zR`p@u1h?=98by{Wd!oAQbRqNap(QJ zgJKt?yJmBxTcYox6DN2jcH@j2u>HWsi1-;TB~|DS6AyXa@| zIDGQeuF$^xb8e~r=T}Ytlf3WI|NJ5S8xQ%T;0G-)dM+*nPr)z!qQvXb|Il~!WwWLW z;eQn#ruhQW83(WT`JCp@^VP3*i=X(!o2)FJplI&x;>#V!g=oS*SopT8dZDD=l; z{jDcHh#!gi372JT_;51mV0~^JKfVZWfVbxRgU`7#_}iY9{;kjF&?&b5^Zv%?#Lgur zI=-azZ;f}%IawRHHy)p&%}-7J2sHzY;aV|Z8Iu~h;;KuIt7m+}!|+p+H39?pK{Qbf zpR)Ux{%7%vUewJ*=RcSJhaP{N{`sK~Z9Z5_p74Zj-aYTxZM1RviXQ!)@eiTn=8KOP zciv0C+8+4?hKdC{y%5eAB~s?z7*% zjmDgvvvpC<<9GATw?_Z?7W^X}Q1L~0W%#+-t-`nbD(9y79K5o&bUMX9&==8{HoH~Y zUy?m5*he3nDL&C~k9WcYcslww`X%*uD<;EPv^MCserv63ee3VJzN?LM^VGmEUh3sJ z`^C$^xA+{i4X?lsLBFOiboi;^6Zm6Sdvl}vMQWcH3rGAF9=U` zVy@jS<1j|+hc80Q=yb@A6_1907H9uYxpu!HpF^L6HnV-;i^Mk7zSD7u`P2TOoKO8b zdul(!)!@*X(`Vu8THm?WzOJpRjd(6+9-jl><16d~JVS?D&(}A;knNQ1pA8g`c68=` z-^gDRyYJpDe&#d7_rIwdi=C_a8HP4k^JW{P`|)8Hvln0cTJ%2yx={UtdpsFkw|CHm zushJj^=sKxd;B{22%L*gHV?W8u^6R4skXl1V{13?rAo|U@G5@XUaZRgPUlYl!#2Y{ zfKN~};W0xQV{PeyJ+NoS0N)wUGom+u1+x9M!4o?T3h zTrje>Yp-7)?Fagw!QXgZ@4hg74xfWh;P(OEDi*gt9ylD%asT(B zm;9F1^Rj1frt$Ro9CIRP@HrDp#}}MU3NLuXQ2*9%Kk&aA=!*vWpPf_Ncu?n=4!CSr ztHLj}?)`P?U*l_m=i`e`|HJl%w}#*0f__`S@pW(}cw;f;fL49_FEln(;ghpqam@F7=*ZvJcFzx+q~ zW1>SLgVEXz_32){EGUufUs@onQT$d~rd^gq#mPR3q2b&tR5w#poKi2kGWOLR48l3W?r zWo^!lZL)ZLW59!vVT&)q!;ssG&$&4JMSd}V@CirZT{aFbam|^T<%`lk`GAh!J+P1G zpaUu%1kMsC!G7H87Nuqt{rj3~_UNzwVJ|RF^c#Lb)5`{?7L6P!@*q`B82lc(hhHKm z9iH=9Ixl{>hve@^k1y`F-DRh4EOy4m4nAK)BwDHun~)#Q_N;*mq2AbbwKtN0@P*Zl%())3F6KH4X;ZZF($*;?lxsIwt< z%%0KzsI>)u(7~bYbH!iSbK`~w&>r;AybsPE7S1dAYyPvJ(=E$-^BZh2U-S^c`Tm}c z?>OFnapbPC_zu!XkG=2x-OT;(*F7j}Z@%#T2lFmEAikt?+26rEc;TahUokH6uV{7g z?|oQ9bG0Wgm@A$FzQ((iUva;^-{>!Y3G-zS#0!E`a5&o5-)lpAtIex3FZv&~C+R|d z8QhAGf=5c;gzJjWc}#4+d=13xp$BJ#KQi|h23EJq-gv*gogZJ@$&=nOh>f%EiI1Rj zz~kU|n*UGY>1O>;hQ7J{d7hl}^UAE>ry~c_|KP)%O*s+t-{)J%Vx|B2Y4{et$ns>+ z*N_uO+oKf)Klq&Di^$rQ8=^m7XA67{_@XVt7j4~YyP_)QUYTmoLPvQQP za+cINy*NCYn($Xg*605N&+ZT(Pkr?H3UVTO;5Xrm)G4(G&Yt+M(igS$r~l!z3HEzF zgQWv%`XB2*jAyLz>=k_cwAgK&@gHO?Y@hT$V4`AF`r|=^tY_2zg#O(SK8OAX?^b+f zpKpQ3@Coc1aw*|+@J0N8D*mqD-g$?2=p?UfcCnqBT?}8s)^2?o@0dL(m|oqw*FEp> z``I~LYAhPVb@2nD3%Mw3Dvo0=J_k*sTciWLGJKI({g3BtqEn-JIhMrU-t<4web%~{ zolCsXMEv8L{^!60yCwXv?tDPE$%^IOvm#%M zre~MACZDh7jH0LgwtnM_w8vLm7QRBg!#}3Icg=-Q=p)E6;GLaC9tO1kCz*fQJ^Swf zM+Hm$>!ZJ`%~){DX?gd+|0j72V#oYua0))iGyHALgWap}yEu7r*5zb_z}u%{YcJio z`Rx)OVVgWVx&NKI@!k2d1jdUmLbu-@9PyUu5=%ZeNBoLsUX=d+HvH$NhdikpkB`rCXTTnW$Da~| zl^90w&leg`)IR)w_#}q+-+#NUyW_%7;7!ygh`VVxOzbAj5vgP87=>gvtT>ao7 zpMy8S=irIp5VA}0MSP0X75-4JiviU?K1Y5F?diL`yJC;j6U29YBx~{H$Zysc?Uy5o zKAYac8I|j)zs76&U3)Ov4j+leqdRmV;EQeaX?Y*~JKCO|&$-4AHUHPF1NwCD@Szj? z-LYE|zaO!P1Lt@&)80elg=n7#N~^gjnbZupMDyTAxO7r!{r{|tQPt$Fdj z{W0By&&k;FF7g+>Ir~P|>9?)l&r1KL|0%l|xT`&`cJ+-GYOilR0=js5a6#qnEFQDk zuj<=gT2p&bd=4Cg=HYYj6h8}1EB#N=S#-bJ!-aU1?*}h^Kf0n%WzWFdqcX7E|DV_VD|HJ=>{^tq9*oi)$V@}%l^*?-htS4DS|KQV{{ibt=r@%cw7&`KR>zBgc!yb_P$&8T@ee=^uih#iFdg ze5PCPu6J!b&cfv7SuCD0dI&OE$-c!GH5w5aLHtnbe>h*b9InBq(+TniqXR-m$;AD! z_>I<*&G9XlH$G>;7ui2{iqZCXJu+LLFQWhXe)!UoJNnO9U;0J)moCeA8XuMR>b}1< z{b;+k_(xmwLr2LcwI6H|&Mf~QeDdkZJH;zr-Fy4m~e0 zp+>v-kAh`mz^fZmpD!YZ4fvcLVjteV`K}m0xI_owsmj-9ZUeq(;72VsfL}rJIdBxZ zSUiY*hyTGme<3zRa_qJ_8{Sdt==WToIvbD7`E5R}=?mS*W0cP8Z^HNSXMAU9>)tuj z`k@OJ=R@vfdwp{7WAS$Uq5df}>-ozkx;?kwwi}Ngc{=%&8eJ9p_1*8bI6S(Cu~)sS z6VqF`hyG_epDkYgvUYBc$o{`5?=haDIo3!HY&v!}2jgLz!nd%AkyY`A#^~N{^Gy$G zeqtS5!{?y2+M*GCzQ}%vTgF2?CAM*EWdGI2*53NCqg5_gdrmh-m+|^d)^Gks-m#{& zud_kV+;l(Ddz10lis|68@ z;@$aSg$EV$wIp#DkZj+>+FNCtv#->_=X4IXJcj) zGk)jK8qMV|WL@z3cx`$d^b$@EP20nY7@rGBqz?X{~ma<;=U z;)&=&ejYvt4yXSq{grhs9K#RJIDV98*r0xx=kOq4rtEZkzm0q38H8c&A{lPxs*ix-)C?li=ZB zWlVGlY(XWT_W2fTOkV+Be;U5!*J)2*M5k4`9!j5Mo#>jKb94S_*5-oXVtf&p#iM9r zeazW&wXU@ntNJe37XL-x^Sg|r>3>4g{LRM%F7>?e7i{x~Ed9@Qq51rB&(2uPX@_BZ zXKVi0ST`Adf7!Xo3&#H;c)jq9@23BWU7jr99W|c4LK_bo>VLkUIQol9|C4u=ozXmt z4*`R42s@WN!hQV@o=o4yUhUx}`k%%Z4fQ|pw>_(v7UQq>@E%xi`XBT)`T=$^{y$58RQ*&@_O`lrN=S9ZkH*E~phj!DS(EpGziw5-jq9Tgw)wqf&D;79^$*T~Tqokc7KS%k{D22^^Y-4m+iYs0d)CZ&%Ypo#SyQ=)F3sn2 zfp0QE^0wG5J^orP_yYxhCfZ zuUG4cZfIY8Hk;Rte9?C8jER3TSI-y^-yg70eXPxQ?G+v3Yl83T0O>>a9nuxLU3L$0 z27Qb3Sz}U9gx>$7S*N=W?NB>LZ^X7icQ5bigC?>M?~M;)U>|Q&_=i8P{8eJ_(2%W)q(Zf79eWLqdfzK#f319Qkdh8JAt z`sq1i1h4(J^&5QQi}*$3i^^Z9=wP+0Z+;ZoYfBF1uizY3eVbLSZ9QM#+SyC%T6Bj` zJ31>j0sQ{c*rE6t+3SM2KAnOCz#h7GX7I*WBLjtV|MYkk5 z0b2ea`XBjuLJJySG_;H1nWp0ZvtDqYcNiz!59Y1O*})rpZs24-N9Cht&5N#;{>R$< zB<;nop|O3x=+=JNKVHxI(H@_JFTxk%y(*qg`&v^n*jq9l`>KEWk;sL71L%=zZP)hO z+UvW<|NPjX>3@EkahLuFUnK8A`Fh%`(ih=1$eR4vua2zDZbD!8mW*Ym#HbsG{@XbZ z-`{-S=pTl$7loU|gW;FZgued|T59hbpA(w{A6WVy`(1wK#$ND4mWL1UiS$4CB0L8D z!V_1c|KZ1mevtS1B-8)!g{tva|MWk2K5#ErH~r5wp@)1S=zoef%!MmP_oVi;e;u!9 zu3~ro6ut;w@w@Ovc!#;adEw>H(OwQIG*14&ep|os zdf*vf#NP>DMCWx@*1u{J^q)a1$UOXi)GyKhANeoGhWM`ZqwQSl+V8{f+8;U-XPjSZ zJu4m!pL<=#V}H-i8LJu+=np*F_esDPkxi~meoXMgZguaW%^cipoc=e+JC`IM_q4Sa z`0Q=h}4sUYgvV+HSmb$*k-r78<pMe=^}WhvQ{o&(=ic3Cw1E7||w58HQl*tOX}OCPwV z^{=%@FUa_8?rRYk1AuJ? z-Nq9=C9?nB;$N~c+kDn}g|)W_`S|VHrtg1WcVKub_Ldjq89Yh(Ji+z+W8mE<5Ag^- z2W>_l@M+e#bP3j!%?e%QzidswE;-Wp$^D#y8aH~M>iCh92IOY4CDB@>Z_j}6T) z9V$De`f2Kwos#d$rMRZGulsmSc{JcjxQrYRZmDkbR?xG z?6-HW%@03sUa!lXk4)PGvrjXz&&$7O-P_vd_wwl89u``1bk^$4X%8;&Joei<_xtwS z+Te5O*Nh3T16JtNR>hCoEAe0Eir2vx(Ib}rWb_?!EunjKOZJ^CfS)a&u+jFlwxiek ze^(pz2GRMSMFwj&qTm~RlygwyaZZXZi~B=o&(40+|NJQJjR|cm`BdN4p3Vku4F0~I zcYHBC)cdo)@uMjUIO`|{}6mCmWZF-scA3wnl{#^*5^*SCVqo0^ZeM+#G=dl>x`B@%~+~`be~Ob zz~}7Pa^_tczDT{Ox%5BmV&oWht`;wrF_r$uxiFqSU)|ULsMUrh@Q1}`(7|ip;B)xx z@3r~VdcHWgvg~FzWG(SI7l+>3^Ri3y`$K=lKZ^CaF226S7vaVFw78x@qdpf}fH%H2 zd=#GI!t~FUU;cIT@I~SEJtME*fX@tH7k*3seBZ^?&t(V41Au?=bM#R+ga?sB3LUjK zHIDkmi^2K$s6V9t;)~A6-{QxsU47$A*bkZ?a>lLwpP~a|XW@P(XT-~{|MeH31wFLuqv8p7?xmskfe%-0V2BD_(>CVIwL@J4tx ze~TC3CveTK1HQ;R_?lFI`ZwqD1Gg`y=e+!(_?*nyo|m0Xd*`J7u5qsEyY_&t;lshT za3|bS@eJ@ex+l*E+bEihcM#)kJ+(`n0ZtK>;~Cw@|F zE9%=lDm+G=xr0NW#Uzry`RM5%kEKt2TQ7E$;*0(!YYOM1W$1^sG*3`5$ z`V@QD_ZO-&qP?11_#$n=Ek1#6UQTlNYwUin?xS7#n%6VnRe$)L^KveJntk^U>s2t( zUmvj-_%d|x+_dK(sXe~1e9rpq**(=U!55t!zT$`BjkL$-&=1%6J>xe!i~U4<@Gbn2 z$ev`A(vKQ@wWt3~2pGgo;7 z$ews3H7!=R-mALTUmtn{vOE0`KWFuoE{Gp8{84fhSSy$&+mKDwG5M4Bp;Nz2dwBfO zffMg+?emP^l}FKerY{oD^}GBw{-+Pm7#^Yc1h#f(5kC6EQ2%pTXpk5=ai{t;mTC_M z?G3u1uC83dxT1om>K^Y%$oc z8jEMw_EXQSO#i>i+I6>2O|iYg7sa>5?~_7%^i|`i@2TK(HoV#P;iK5pJ`uUM-mPu5 zcNXX=X4~Vx@{X?trV7XQ+w0@Q>1)tF^E9q~ca4sAlUdzI^Ny9Ut}+w+y2^Ae>E<9_JQ~;oS*jO#5cu$Rk`}AO@AKp6rGg1XunGP^U|K)d_}JH z+xT7U$yfe$$qR8_bd0}Fd;76v_{3GUM_Z2#Z*p$>|4rZ?t*l&%{qa=)`Z+4PopaLu zg0xp(<+iaaj`r{G`aC1KTF#Cf@!OmMv6Xij${hXvtL@GC?ms^n*zWTQ{qa_x{r1J9 z&UJ6DYxvp9TjYMfuesVU&bk(lw5s;~G0Nd*4s-QY*ZS@KF1T4$|MgsbPY>nCwQXO| zt?t`86g|)m&ghSG^w~lC8|UfS)wOr8_%40jlJ;}$RgFvk#rwAY^Y_hZ-{zBNs=v9u z`~45*zxwub^|7XF=CQhU9DROW`~UlUFuKO;{$97n{~y9YhP>|Ix)oTr0_#@bzkdai z+i~7q@;N4-_2zAr|MTxI^X9FX7<}5_ga1~`bEV1us{8mkyz#2|{{;E-1_tF|MtAU z+49%{%F>5#E zIl5al;pi;O*Gk)cGJZD5^Wy6!7RmmUt=N5QK~Mg@%>A3u9bzZM+waVT4sJu81DdD+;4oRzXQZyrC! z%>oNz1Nj5+HDlWnAK-l}<9D$|+W4*BrhDJXnAu1@vtjOUHMD!MQ|g-!i`=-z364rv z%I}3;&lvd!8nZKB_4N2qwKEs{1bk5AUL73NnmF%lO7MYPP5jgPafbZzjE!%W+)Qta zzIe-_PFWwjW}F|%JI}~@_;%n~ovH1EW2^sd62qka_IGptJ9*ykTMzZ`+H4+L@a{bG z{oHrv)!^&L4Z(fzE#KeYWDGyeSj!K~^UD+K=e)5;!Uu9F9y#2DI`cIa-vtA84IIFC zVvsJ6p9r{Si>dqKVAzAtPXC|Dd49pNv2JDJ&lkkUY~H^6cH1wT?q0LOWOwRz!R6a* z(jA>xtIcN;|FPeG?XyMNzGD4}?xQ(#r$m?kqQvoTJ01IBo}C{bwUsN@?~c#4Po?kk zlK)P<*~&d*416%)pxcWUdr)qOE2AB|n%b(zN<_q#(kp4`SWYG9vzb~l!sEBCz39xc!BQJKe` z^LzZ%QwMp%6N|hwF=+?vvv>F6yyJPvzk8Qk@7zr!7lN3CnIGqV+TJNS1z#T9iyWKJ zNvxpv^XrlykPoJKdGUIDsE-fcaGyQSIyeh(i(H=F-aB;P3yf_vlAp6bcYDk4L3|r~ zYSkT(?}g3I8oekyfgB+G&-r6`e!IZ**2|_^{=F9Wo4T5BFIZ~D+PHeLcQj5d6$b5`R46iZBH*8FN zYS=7|g+C2{2{@9E2D&FF#eu<_Tz2J4^qe(^XVfMXM~AKYwTEqtbIjfKnm?ZLy4a%l zIf5sCiN$|u2j9W<>KmP&^B`~6iujbbzLWP@jVtjrv-u?w2Rr_zH+2g${)Kz)*=n83 z#Wj0Be%Ru{7v|Z8x4w0YQJYDO&TNi^_zH^^coZo73WQtS5EoTG1tH)=UjvqydY zNqs)&{j!X&+0cXYDn6;^U+293_FdQ5jlP+Av2lv2cyM6NeKCP}Gr#41;7iOOr(&ex z!5sqQ>Qc`n=CpkLr;>|64KO*cTF%4xK#PSDhoO!9&+UHlR%)aEyIhHNUv6Ttd+O&c zJN@)-@yYM&?s>p|-D$CT^Ur*F;B#>-GdbfD_r0@0GJ^?&W)?1_IuZ-PrZobHD3TYfyjl|K}s}>%h@D;djX^eZNyR zb?_c%1s*>V`u3Ep&vN}G_t1jvw(BP0dgr}j&cr%pFBjhCHtqhzTi@F7q#ETdCJnww zu9iiie+#zQq8m@mTkGP?G<>36)?(h>?%u|{e$F16TrpvMc&bK_IXJs`7V&F%X8s>X zl;7_N{nLJQP4KMbFuoSQ3k?;+S-yDMqk(*+(Ekr+{!g3^j3tN3ywtj1kTWl?>n7(t z_+UDl7@ zAOCY{#s=Om&N%w`Q0xl3{pGn&UXU*sJ@@RY=)d?FwH=))>%n)PpA7!2;(O5F@{jMA#B$jz;Xqfux@~we?wWw=;Gw@l?`9^tu5mn9y^{p4xbFtl{z zynFnpqq=GNBy(NNO1q!_Hoesb-A?Fu=ox;`9(D1XePd(>b0a5Ko;dJNp69!9PT+L2 zA^i7Yz4o1Nq4mU1I8&8_5{~7|pq;oUGA2IZz`Wc0cFkGbDSVqavgz5g`m?kU0J2c+&m%bO6IDL2t%@a4X@ziq3f#n0$~%{K0) zLO;Z9t{=QQnVc^B-R*$xg~_#Z(v};?M{*!f?4G^4U-%$n0smw(vMbz0KEn?^!r9FH zwCT^?-$noURiXcAtC)NFX#4Ok?;rUWzyIyf3I3I{^l#6-x@D>7xa`8zUzU3V50Je> z6BcZ~c{gvP@Df?Wr{#>iW9#@f=DfV&R#V+}_HpN(yZONh8)lr(&D`D}Uif1=;J5`_ZrRP7nr?pCVtu|E zUKS7awe(eaH1v-*eOut_$2rHBM85rQ=D25YjC(#Sa%N7-ef*95;^$|cm5acA_)h#4 ze1QI6m3=Dz>guClz5e!H*Jg6|$#LjEocD=S%hi03b`_6FXM5y`duRe7q;7qw>_ZzM|nVg=h zo%ftA?a@7F&hHkd9zOZl6_ee5yX?>{m51iM@b<|=+30_0dW(CHJTw^|W-N8$)eJ7* zC3&vI(uoHxeTT9Bb!dKlOTE8-Bua+2F@Nob!BW;{O}JyngV`F1s}P*62U_4Ic!L zO(i$Lyu_w^o*qPe-M>dSaAx`!Ust)L+^1XP_lx%YDDNO^7oX?8vq{gyr1&)-&?{%3Se$iZNdfA1h3d4rqi`_LHtj~W>t3eI{`=D#AaHg6_6 zfE{;iJnv2DfAGOfs)C`ourv9sGU!@;zRQ4)CI!=j(Hx!F`|KAIPg4 zb{7xNyPUj5qxDaB35Q=2T*K!W{eRIK=s$VUyu`}lCFP;ubNYk4yK2AUeM_$?CigR; zHE+Dtba$s6w`=*{(0KVa8vRe62l${qlV3lr+c@W^=&<}5@~gmCFU`A*TRcMPo%v3; zT1Pq0;wjzt?u!3oYmhh4d50U_rw1;-dH4WL>*5m%j>5^c_crhRK0a z=bcWg{LHN}oesXWYIhtEd{BP(#v(@?U;oOLdB?2h!$arH3BG`8 z{@l&K=)c@_V!#JED58(c7|I5t9r;&m9$nnO=UdHNJh*%FcHg7PbMzmL-^cT#|H%Qn zVB2lGd0TJOZ8SO29X6!z-^%mGSaPL4=x4>YeLv?N4d(-2dM5Yb9&5w4K&MBqN+;3Y zpZjo+^A1~-URQr~5>(C-%v>Hj71Cl|-u*YDG#_9t&u=;qeD31V|Htl_I*!>_^7}sqe!SnlZ#je``h`00 zuN|Iu@odF^;L*r&#)wz)ymcvg1b@J<-u(|pFG>g1j4kdQZmjlJN8U?6F%n7CxutzKJeq?D*rGEY$MitFs-Me=;)v zeFBrkufs8HA?QHmuxBq}Kh?kUPHsmB$Xc$^Y2wxSj+0T{hY#e3cAxx4m&ab>w`cKe z{~TIdGQjHAKp#Hzy<%XTHMuFAt-k)79LQehynZP3|B&$Z%jg3m-!^?0U2f!CH3^$c z5IKiVXx{cawEi~=T;VD3x%3NUmi~D_|KT9#U9LcI*FO*VefYq6H%7d<^{DZaW$_2+ z?$?>Gw!W=Ne_gD-m>asbD|24)ynTHryAr-i&GV0-|Jkz@>VGHy&Vp^W zX|iss$2gQ-$#^rrxu9Ek+uOD=Y!(|3eIi^Zl^X}bcr#dY7 zpyfJ?{La4QnUv-&{kKk4SEtUq{%X(JOW5C?6*Sg4 z#{=KaV#shN^EQ<_Ya$|1=glV01zZr9S0MlVfzN ztgAWn=kD)13-YX?|IX4mIg?+dr6_Xk(VjYGcf=i36$a17c0+?;o~1&;AkZIAZa|z4z_=XfRn0K49+?)7IDb z;g9eS;M{%mzn?b|EEKHQdibt25g%{w8~x9DtQ?ufg%5HT-V~dU9G2Fo=+(-s`vy7F zW2tM@r~l|)qyMP^HWA&}lGKHK!ggD>oDk}5y<%vu)3-BkEa)wJBYoXJXRlpzpG@F4 zdwHwDp8M~MeD4}Lu=2+`CoKnb?#qksOrUu?WuFSpSGNY61+S=q{*cIW`bID8iFjq_ zT_60TYF+UgZx3ENCbr$Zqq`f6?6W-d&fMj`mIJ%hMGkCCg#J$_=cD*e&(F`;z!V${ zZc82@vpCQ2ul)t{WcN8N?sWFfNieN55wo;S>XdUtjURoWL?dz zV4>#f8(h>`@V9kF|H9!uO|Li z4YWr8%{^-{5u4vk{36!RIno!O7MUB#O{HM!WZyCyPsH3xlPKyq`%LF58w*^b>I+O(KWe-E>ztX{x;|EG2O4TK*xaolke%G-V-~k zwbaIkFCQLUJ^*?Eeq2+-eV7-0-_#jr3~Jxe_u=_--qjvt?^`eaEVtTZW%ty~{p9Qu z{(;W2_%!{)^F{xE7M`8_-w0Ugl~TK?wH|K|m+_j=et z-6UIG)_@*pJiY+U1|GPe8yb)PfBEx|itqAdqt(tk8bbeXUFrVxNw&wYqhI!a6d&+q zviN3Re!%4*-;2+f0)&j_yg zmz>3;vIgsK9@#&6_Ln^9K~4A7YG6hW*lhT}{Y^KKT-fur-L8#+?NE+S^y9}l)9fsL zc>o_rT5mJJrK`vMeqfm=nsSkT1o!5zFTe8e3zR1A30!_21W<6IJ}WI+r(D@Z+UV0 zW^dzDUbzn2{m@}L(stf+pZ=fj$2}i3u=E4$`{;jP-wB_d8rYR%{_5O!ZeKq1X&;?` zA0Fu2tSwk!Poy_+-st|k*S@%~k9TB!XYa?}%qBnW`S`SrN7vKlogAy{r{=hGF%kKA za{cAqRGY(k@mX2kT~EId`piF6|KvFD@LR6(mSZ&cKQff>o#(Pc!3QlzXzqVDew5B9 zI$8Jv|K4)9Cx^tf(dq7;^Pu0_W4~+e@S7ZM&I+9zouM;EX2WM_hetfhOM%@qzp7fqi`$-!1#bR*8RbHv96icZ|;6wW9w| z%Rb;W)wpur`BW93sU5v6nhhV|CGjWQ1c$ljU27DU(Wk?9Nu%^Z#t@<#ol*S z?ECt%pY=RFJJ>6H!1mbBA52I7nIV6`CW%+;+dI)fJPG>&d!IU^m5<20?Q_9;z0-HC z2|GStVZO4?W95}2^MP|`3oT?vlnd__L;pMU8SK&zfQg0=a^B>_h7ZPL`|y!>kj|uX z>B(8{{hlp8^Z3xH#$TlWk7xaj*So>Cw#VcgG<=c%#VU|d?0ex0`pAYaa-WT6S^7o? zia*fD>ek>kq494Gj5*Wrfivc;vCqQ?=pP(v9M%I54+p{r5x34?hEWew=ss0FP1j1NYfn(EoFC*3{J&k3@%8&*N9+ zIsRUrMdST0y{z#vvbCfuWjm;xX?=ef@D5kH ze{RMIw~^KKT{y4CTHnq>*@@V8=#J5M=N&K5Kd)#l-?A%m-rZ++D!&f>u|@neI><|N z)}42HZ17U=f-laDUncs_=h%6z+>+YxI~VidKAj`oWYwE+-}=)((C@p?cZr~*YZZe7rBo|lpD%DAFyKW z>v?pgat^tVHO`q-=zj~Bk4;^XulV1vM+Ad>qzs5+0towh;8ty)&>|@zjN6r z`}g7W*9V5*8d;mqam}rsCx4!pXHQC-g1!Fpfayztvx#6GuN~K)A!ps8IEr*n7+yV z;KR}Rt@}GGu${$*zw7(I`+B{v|6OCj*U)LBZSEJ|BdZ-4`MctL>N-A!9hiLCZ;$`f zPx-}FdpwHvn+$o`x{mkP{}y>qzaM=3U+20QLDy@Xe%Gh=%-G4T7loITyS8$tuFSje z(!a~~f!sadqtJJLC$7_lm7HWOO?Q;*bp17F@;W}9E(mW_b0e$hS3lwhD=)x6N47z` zPM+O%D9;xERO2rhnT_Du=#lWNWCFez+K?6G44?;N6RiIEN#hI832%qLFL{~XpAF!w z_|ASUJYMnr*4E!==Q`P=_ye~^(QlLxfSto#Y@(>&8J{!hMp(uioYiR$SbT43myf0c_*2V z|KN+`W49oEZWMeqmg{Qyu`?bQ*?m#2Z z+{u$*man<@k~@uqUk!Qp*^!&sOuzn2J2U8E&_4np`+x$ImEay7k?^~I=)`^|| zRb-Fyt+uCPJJs}-BcWnvogJ|2y8S3yv32dk6IdjdTaR~!_a>LHy_-Lo&2_m6KC$Wg z-Gg`DzMF^*Z2Ie8@227p@aP@3>0X^!sRwPhRX3Ho%+rYvoOsQN-NVxEmAU?qtvBzc z<1eB8MD9O$*B!f0hPQu1&ba=~fsTP*Q;i2U5OS3F+V`iXjPJaMDInR4#E`_&h+&AK% z@znep;2*Y$@<*WCw8w1e@5@>(0|N_F2Q%>(%Z-1if98{6FUL~zuCCKji#2q8Y3$a^ z`7S5Uj=ox*PVtO0x%ZyH(r?M}v5%Jjr!|My)KXE4jE+!0K7ClPdBB(S8D!F<10(P< zA87rs&%i%q{G~bL+ozA|;}S!cakQF2u`7!SolMO5c;-=dWp*~Pv+eo`Cp3SPW`nvg z_SdwVj_>V~%shT18yIUbnu+6T*JH1pPRy$7&dBsbsA4UT>8%vkr3 zjiW=2zcv3$aQ1-RlG8kXs^Z4sA2{5%ae!fX2|kfKrFgu8ox(r-!mbI;kblNlOD`=x z1peX6%UA5r@K5kb!!z-ZwI=G_y(~E|z7-hzVst-S=kG`$?fP3o^L`MTbz1z+BcDWv zKELh9J9GV)dGCecvkL!Mw^o-fFk@VNzx3}j7yjYnM-RuI_maSfc{#K258XVw4qCP- z_y^veO8g3#X!s}oD`Sc0=hvf__Yqrf*3QpA$L6E`%ET`&$Tz$OpYRD^+`FzOT^Cya z>A=2yXZr!OauO+V2e&8jF7bv(XIP#5#v4g@t>{@d37&E>EPO~Q9|CG?*2W%Oi zq>Ohmu*(-`>RaE64|eR(@y}cTh$Ff?ER26Z)`Tz3hoU1Zo(*rJA2#)mW`55NzvFLw zCw!x>=4qLSHS_m=(d`=#`!c%3kE3|tf}znpfqyOz{=sjkTlQ!8XP2$JBj>_DscR3P zOvs%P*x-Nh@z|Aq8$B^Sc=6KK@bjTfmxfOeD^mQA@#44OnJdF5h%YiW{EzE$KXrMg za%YY5KlaFZ_s!o_%}%igWC=Qd_~(S2vCjmqAC$8>_7BhP#)9L;Lh}zU{4*V&P;uU1 zhHV1OoD$qX|E?eXwLJZS4gLl23qMcS#j%5#F9&AGUwmiKpMs?;GN!)2Q^C=|CcaUl z9rXL=;4Il&HW@OQ+HClhU2`^OQlk&wGm~*oef6sYpN=noxtj_-J1}_W4I55(Pw&Bo z{=lL-TzF*tvI&3<*YTGx%Q?`_b$bqG*i~N}SmN6z?gCHNhxx)k;y$m=Ilnyf1NYi% zSNKP6l6Us;&liULPhh6upJQL%+QUCDP0pV02mjy&OE--_`C`U+S^9_1D$W%w8T%E1 zjoRh{t2PoWNUk^A2zEqGZyhT@IO9tGCp|CB9QfYwiwA~Ajlnx$Cp@NnAaXj4hnKt6-~WAg zw?*^2sf7#M^X%c|C$Pb%U;khROtLq+e$QOD7huMI@WBUL+JkNWiDFX3eaywf^=See zXD`8$ITX$v$X}_)-0)BQ8nX`O-}s-KAM;xybCwS;{mNGZ z*I?tffu)k=jkjRw^5DO|`~{ZaD>h{3(|bqp4?IQAwMYD4_@ap&u~+Q8@Xu>Q%Riqr zcyRd7rKy39Z-#&H5n#z#nEK!c8ogbRe%Nclz{m1_FjKJ9?9qW4ys`a7dyMC$Lsqghi~ zZ+zTTe5j^E&+fD9j@|2%L*cN%ueCt?@h@P5uQL1tX7mp>$Q1=k+S8Rd@5W(2%oRTa zwks~PXjdQq{2^x!e(2*LdwYKPlHZ2!W2>6we?p^{%Lg%we~xWy!cY1o%f}o35%)9~ z{*i-2!ekkuJ$ANdS@#?Ijem)nNky8;&x-MU+>t7Ge!ZWj# zyWVJAuFHc54!|CmGVg+$f+OF2|!p;2Rr!I_RP zmRwX*U-`-a|Ahb9IDG$o7cWQ*&%#FY@E~M=u%RFG0W;)V{)TnkxcQa14rYy+?~pTK zT=bhKhxU7ZbPj#|BX0SkA^u_8Fa8Jqp<6sX`kW)f$Is%Q_*1q#L6PUzPwnW5&|&o~ z@jvhnJ2{`(;(x$Am;oF3pTa-p0p4A|G_X**#NvO%=J0ucLe7Qp+oS$G@R|0=yu~o# zrQbC4UAOl3PTkpWz zchB&~8yx+DZZf8$yr zyRLs{K&(F96IgPcE}70A%<%mzA2zYCwO6C~=RtupGV`U`Yx>~gf5`v%l}mE{vw?-_ z;LfK1`TXYx`kXoN&x^xbe-Hl?98PYwR>rRu5gPQX_ah<<) z)gN=O59>7#GV!GuKm7BSz>M>4?d>5S9kA5mAhMTa@QL`3qg7yrE&={o^6Y1KV~==5 z_q;7OP94^58gC5$!2MwLjnR>UnXg0+L9_JlI{wmixn;qq_F|BZ$1f%4%MUXz`f;#? z*EWZ_@DCqDGzP5Wo$NK=BWuUk(DR4KH~gQI`|@6Q*t^C2EGKgX56N*R=hay9BW!y3 z)4PW*O>9~CEik}8Nc=bZi+^&bWP_vT`&E?yPuvs{_ z@JxfHT$k(EJAJ^?2@RIw4-`57_Cwl@$FH%2JMWUC(q1|L_&jT6kHG-{b+$M1C;sGd z!7nF7R=I0nNj|Zri%2~Ez4yI+_v&0fIP!w$!KD7sLVO{eq;=9iei4k)J$aA4=Hrjo zHxAeN<+-kX#a-69Ex17!o%2gVAINOxZI9^R<;VpC=$|v-I=u4z;1@QCQ#YDUF3`x@ ziGSZb-|r4=os;Ww>=yo^_XaciVMn3o(+}E?X1Ol!Q~3hfYxLjs%QCL=@$pQJ+3%VM znOLnv_4>;HlDuLb&JDcu;jD%Ig4@u;^Usm*T$e8hzSADeh#{j7|3!2W_R+oaGb_01&tcz*vFzbYlW*8CK9zBR z8L}ncNO(hBxftn#hIoXIn?6QPt9R!5LvkIAxn8ire^HHKFy}fs51w(B$fU+5_QPI* z8Se#4V2lqpydnM`jVryhanCge*U3G<4bLoISFBR$i@=inYy9@WM%mHm#eR^#*TFjIUE7{|MN@1?;%mFvQO;0yF4##fw*{tN&3 z?PHI98_!i>DZYPvK;Z`0#hG6iSae+;7VGIc-Q#%~hwB%m|IIT#*PRviKG)et`5n3r z4(KDhJM7$D6I|JH;O07*`j6l#*KY`)bDQBhfI(*jY?I|GhgaF}^;w@f4|j~*d`x(+ zl0S;q+dF&nqFgUIsIJS$_QG73^Hg7Teb>-L{nWXv>-_(;FMLwhx6axfo$KYVT4#0h z;G-AhdgT`C!%mI8zDMuXoa(#U)!+4fORv}aM*FGj^XXa+j~3TD_xBoK zRCMtpq2KVXv3x!AdSCcYJPh9V;|G3R&-7%5trjK}5w>0|U<967p`&4M1ycBdv<}Hsc_(1Rc&2Cck%NWd? z9mrV86xQeK*}r$tljr_K>|S(Q{0heJdCzX*e)ns?{XKTzf!#!|`Ry|i8?beGTjqJ1 zapb+`B2OEhgFikx-Jd%+{bT6$7xGSH^#0F*Zz4qE`uRrMT`o&x} z@jk*jTYu8HmFJ^2Ou9K07A?yAf)(l$RH(V!N^Ge}jJQHvtTOstY9-EEB&Vgq-Z9w` z>Bhmq9IH7DT=hsA>(_d2S6?ms_kgcXsk5F%dmEU-_e`SaF*i=7E*UiTY_#>9U5m9X zUYwe%{a0g+t;?6C!aQoq2;2MHx8*tVG~bf2KCd)Y=T0&n*IFTe@;E?LU-*BJKXn#)ao*Kte26VLz*v>Pj@7Hj_|Lh}7G&PD^GA_Q*Tly9oSRRe zht?G-*V`w7XWe0Kfi!lnWXy*glZSvG^jBXUn|oQ>9rZx{JBHj2f@kw159iv970#oU zh)>@Ny(iM|F#33ueIxgz>|+;p$!~Lrw|?pfaRt{~`l#BI1GK+_*0Em~@WopmeS=?o z9K6LzI=L?0jBRTg7|6A8Ju7c)r-iy1;_wb@EbE=gH{0^fnmplKzX$A}@SPo-_pLpz zuN%IxziFF3C(p{W)!IsR4sN#0c=C53t*23=*VvSSK8T%G5 z&(63u5|4w>P?|fp$WQMZCsXcXUJKmy{}cNk=dcfs$2g3(;}AAqnQdb~CdaghL&*OE z^&za)t9^I9={w4cb!XHu+h?6`;J^6THpXY2<2aM!Z^Dl;IFGp2bzN^>hy7Sz@lEhp zk9}=kvLv;VOX9amO21x7lb=|T^Vgh{-a<#!Z{K6A!eIM{b%Ew<00W7@f}vC_fwUJ+lA zC&rEM1XrK;PaExA?tZGgajYl6VHme*4u23KTX-u$0uyQif6>{q(xb^d*= z&VTV%p2S-^m@DG_ee`{X7|v|YTV0>`EG?Xq{05feaqQ-toT|55nSYdd?Rzsdp$dHe z;tgcYxPW@cwSZ9@^NzyOICqmbgAXgv?f=T|j7zd1ki0kuKY_n^Zk=#Baw-&}V;)q4K+ZJ+9a z{Es-1zsYmq>;YG8vGGWKkeA`Vd+N76^<*l!k4p@#)!JOt=za!2V-GbWtbZXco@dp! zQFe@xNki>{czb_0ZTE|W8@@;2uFPnY0&mX*j)K$qSzUR|O~`uYKRGPT*n$G}-#ugd zH8SG7DGug_{|Mgt8n(|v2lYMl;3Mc@jTUW__x)?+zkATG(H*lqQbt{)kFY1Up|?AA zuovIPHwr4$Ea|xPOX^;>G)b9A+0ZRUV8Bn9Dvy-_kn#;Gluy z(N_J83_Fk67PoI{>rdJ)JiRL0LG^zezJ|YjhVIL6{ifVTcEnqM*0%EC+4Qi3>VYx+ zI6LSw>V$Kt-~SN@b2!XNbFA{}ZsKR|AFZF=lgi|VmdW=UoYkF%$&K?oqqxgo{Rj2i zws}tSNS#t9>`U6Z?-Ds8fxCMgX>NC}CGU8Yh)Qo?iJm@F;n{qB4jDPt~@b?0;pniv(I|s_|kT+{J8Rw6^z8FKq?5ttc zSYz-$+H;{xJU0)#BVOol-t(Eb@4JmP*YBbou`HjN4NamBX7E4WZEQF4#{2(8yAGGj z|M$;01!0MCUHn~*Qy}oy$0@=u=CP}DSgs|7Ok8v2e(*l7zT_kmh^j&;Da{=R(es#SB2Rv$S6 zBlO{Zy>p}UyYO9C-A@k5_D;TUwxE_e%-_bRDY0K%UcWB2U%ZqiE`2=h!q#}!T_2*4 zK7{R`XNJtv5&l|yvJz{-5_^N4tO4C~E|F{6cICI!^U#CoK)EGVscq-FLt8FiC{-4FPxE?bH=nxFBs{p6^~bkhZdRse!-sC>mwg`n}h{XRo_NA2X|c zY50b5`Ptpju*UdaW$fll3G;gRTfu(}KHqhtkB!qNWqi#^s+QW*-uk=x64%0S$$pmj zuMvOGP5^%v>%g7lJygNXZ(+JW==|%|y0Zb_|ND&3X85DPhjyEQ-w(c?S@#|1Ft7iF zU(E2U$dEp9ra$}qy|w=IN*%uMx^K`3-}ztq2mHO2V(Nka?d0i~;o&CM680%=eYX+5 zH2ji`2SfPX6Igq;69?!;?)Cz|25!Q&5B;vdKj15W_UCthYUI&rt0zD9XpWi4 zvwhIpcl^eLSJ!Th@U7>iPMH5{e8YN|hf9Stz}OGbr}>%UxRBrFyH|57^#cQk*z27M cJb# Date: Sat, 4 Jun 2022 11:49:33 -0400 Subject: [PATCH 311/585] provide README files with pointers to the developer info for plugins also add a paragraph with information about the ML-PACE plugin to the plugin developer info docs. --- doc/src/Developer_plugins.rst | 29 ++++++++++++++++----- doc/utils/sphinx-config/false_positives.txt | 3 +++ examples/PACKAGES/pace/plugin/README.txt | 2 ++ examples/kim/plugin/README.txt | 2 ++ 4 files changed, 30 insertions(+), 6 deletions(-) create mode 100644 examples/PACKAGES/pace/plugin/README.txt create mode 100644 examples/kim/plugin/README.txt diff --git a/doc/src/Developer_plugins.rst b/doc/src/Developer_plugins.rst index 9bf52801a7..36fdd010b3 100644 --- a/doc/src/Developer_plugins.rst +++ b/doc/src/Developer_plugins.rst @@ -276,10 +276,27 @@ Compilation of the plugin can be managed via both, CMake or traditional GNU makefiles. Some examples that can be used as a template are in the ``examples/plugins`` folder. The CMake script code has some small adjustments to allow building the plugins for running unit tests with -them. Another example that converts the KIM package into a plugin can be -found in the ``examples/kim/plugin`` folder. No changes to the sources -of the KIM package themselves are needed; only the plugin interface and -loader code needs to be added. This example only supports building with -CMake, but is probably a more typical example. To compile you need to -run CMake with -DLAMMPS_SOURCE_DIR=. Other +them. + +Another example that converts the KIM package into a plugin can be found +in the ``examples/kim/plugin`` folder. No changes to the sources of the +KIM package themselves are needed; only the plugin interface and loader +code needs to be added. This example only supports building with CMake, +but is probably a more typical example. To compile you need to run CMake +with -DLAMMPS_SOURCE_DIR=. Other configuration setting are identical to those for compiling LAMMPS. + +A second example for a plugin from a package is in the +``examples/PACKAGES/pace/plugin`` folder that will create a plugin from +the ML-PACE package. In this case the bulk of the code is in a static +external library that is being downloaded and compiled first and then +combined with the pair style wrapper and the plugin loader. This +example also contains a NSIS script that can be used to create an +Installer package for Windows (the mutual licensing terms of the +external library and LAMMPS conflict when distributing binaries, so the +ML-PACE package cannot be linked statically, but the LAMMPS headers +required to build the plugin are also available under a less restrictive +license). This will automatically set the required environment variable +and launching a (compatible) LAMMPS binary will load and register the +plugin and the ML-PACE package can then be used as it was linked into +LAMMPS. diff --git a/doc/utils/sphinx-config/false_positives.txt b/doc/utils/sphinx-config/false_positives.txt index 836dc4efa8..0912a63352 100644 --- a/doc/utils/sphinx-config/false_positives.txt +++ b/doc/utils/sphinx-config/false_positives.txt @@ -2369,6 +2369,9 @@ Nord norder Nordlund normals +normx +normy +normz Noskov noslip noticable diff --git a/examples/PACKAGES/pace/plugin/README.txt b/examples/PACKAGES/pace/plugin/README.txt new file mode 100644 index 0000000000..85490c3f6c --- /dev/null +++ b/examples/PACKAGES/pace/plugin/README.txt @@ -0,0 +1,2 @@ +This folder contains a loader and support files to build the ML-PACE package as plugin. +For more information please see: https://docs.lammps.org/Developer_plugins.html diff --git a/examples/kim/plugin/README.txt b/examples/kim/plugin/README.txt new file mode 100644 index 0000000000..eecc6cc7b4 --- /dev/null +++ b/examples/kim/plugin/README.txt @@ -0,0 +1,2 @@ +This folder contains a loader and support files to build the KIM package as plugin. +For more information please see: https://docs.lammps.org/Developer_plugins.html From b0d2cc305226a109328e16ab58efc4970a4b991f Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sat, 4 Jun 2022 19:23:32 -0400 Subject: [PATCH 312/585] we can build a plugin instead --- cmake/presets/mingw-cross.cmake | 1 - 1 file changed, 1 deletion(-) diff --git a/cmake/presets/mingw-cross.cmake b/cmake/presets/mingw-cross.cmake index 29de394b8e..13cfee9018 100644 --- a/cmake/presets/mingw-cross.cmake +++ b/cmake/presets/mingw-cross.cmake @@ -46,7 +46,6 @@ set(WIN_PACKAGES MISC ML-HDNNP ML-IAP - ML-PACE ML-RANN ML-SNAP MOFFF From b338781f8842b21a3ebc0e363d292b4d3f51089c Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sun, 5 Jun 2022 06:52:15 -0400 Subject: [PATCH 313/585] cosmetic --- src/MC/fix_widom.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/MC/fix_widom.cpp b/src/MC/fix_widom.cpp index 0adabe5eae..0a20e7adf3 100644 --- a/src/MC/fix_widom.cpp +++ b/src/MC/fix_widom.cpp @@ -273,7 +273,7 @@ void FixWidom::init() triclinic = domain->triclinic; - ave_widom_chemical_potential = 0; + ave_widom_chemical_potential = 0.0; if (region) volume = region_volume; else volume = domain->xprd * domain->yprd * domain->zprd; From dcbc5256fa9e037ef6469f1f3c039d9aaa6c3385 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sun, 5 Jun 2022 12:30:27 -0400 Subject: [PATCH 314/585] additional OpenMP suppressions for newer GCC --- tools/valgrind/OpenMP.supp | 28 ++++++++++++++++++++++++++++ 1 file changed, 28 insertions(+) diff --git a/tools/valgrind/OpenMP.supp b/tools/valgrind/OpenMP.supp index e1870e668c..15531fa8ec 100644 --- a/tools/valgrind/OpenMP.supp +++ b/tools/valgrind/OpenMP.supp @@ -134,3 +134,31 @@ fun:GOMP_parallel obj:* } +{ + OpnMP_open_part1 + Memcheck:Leak + match-leak-kinds: reachable + fun:malloc + ... + fun:openaux + ... + fun:dl_open_worker_begin + ... + fun:dl_open_worker + ... + fun:_dl_open +} +{ + OpnMP_open_part2 + Memcheck:Leak + match-leak-kinds: reachable + fun:calloc + ... + fun:openaux + ... + fun:dl_open_worker_begin + ... + fun:dl_open_worker + ... + fun:_dl_open +} From 8f773be2d6c698900ddcd6f063433dd76aaa9ed9 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 6 Jun 2022 15:01:25 -0400 Subject: [PATCH 315/585] must open files for xtc dump in binary mode --- src/EXTRA-DUMP/dump_xtc.cpp | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/src/EXTRA-DUMP/dump_xtc.cpp b/src/EXTRA-DUMP/dump_xtc.cpp index 3c5be6b9be..8e0bb4a0d7 100644 --- a/src/EXTRA-DUMP/dump_xtc.cpp +++ b/src/EXTRA-DUMP/dump_xtc.cpp @@ -433,10 +433,10 @@ int xdropen(XDR *xdrs, const char *filename, const char *type) return 0; } if (*type == 'w' || *type == 'W') { - type = (char *) "w+"; + type = (char *) "wb+"; lmode = XDR_ENCODE; } else { - type = (char *) "r"; + type = (char *) "rb"; lmode = XDR_DECODE; } xdrfiles[xdrid] = fopen(filename, type); From ce646a38596be468f4007ca3863c09ae79910d4e Mon Sep 17 00:00:00 2001 From: rohskopf Date: Mon, 6 Jun 2022 15:26:52 -0600 Subject: [PATCH 316/585] Working derivative extraction. --- examples/mliap/Ta06A.mliap.pytorch.model.pt | Bin 0 -> 2087 bytes python/lammps/mliap/__init__.py | 2 +- src/ML-SNAP/compute_snap.cpp | 178 ++++++++++---------- src/ML-SNAP/compute_snapneigh.cpp | 66 +++++--- 4 files changed, 137 insertions(+), 109 deletions(-) create mode 100644 examples/mliap/Ta06A.mliap.pytorch.model.pt diff --git a/examples/mliap/Ta06A.mliap.pytorch.model.pt b/examples/mliap/Ta06A.mliap.pytorch.model.pt new file mode 100644 index 0000000000000000000000000000000000000000..fc2e10398ec6fae4978e37c11ac899615096ef7d GIT binary patch literal 2087 zcmah~YfKzf6rSbHP~Nmf(8a2ihhK`>yjTIC9p(ZBYJ2SAmAoeDAZtgwj zeD~b%JjTZ)CQ(#c8nt5NPFXofsRB7nV~YujtjHX`O%pX8$@-!Wry(8E z103Fqk}k>|N8=M3=qDj#1lIT=lg%d9y?kKcAg=~FK~V-Y$TE?$*>yxFYFuALlHzqB zr<2Vh(mq9vG0Zg$^VqytQCLMbZoVllU~`FB(|H|nLHs&fy4IAgV~dDXQutu3N)%+h zsa9xl5mJH?32AVbd050IV_STNBq;vx(6slN2~i?g zwB9SE3z(%1BXFM|?iVaZ9uRUm1?!C)1?w>n3YOcYg5_74V7XGxreIgJNUw||P!TZm z!X?Wt+hLa^%7|C#UDg5*VNW&v zhoKk;<2(lSjFWL3gNKisoHgjs=!dOi=H`)6*ye{O78e%PEAkq6glYlbE7S-UtQ)oq zb&NxY9VXlecp1kCG+R(DI<)$s&4SuF3Xl4sJz|ICF)Jj@2<-AhhaHm6Xh?S3A@SKE z*<**qZ-->BS#P)q`Vg;2RGc;Y7$>_1`>90q=wTP*i1gyXX(s(aG$;lTJl<)hR!~12 zM$m1u)`yc+-%?8hYbGNuKvK#YJi(N(nHW~)f=COfVi@zP!G3%hZJr{WeYi+9=pk3R zd`xOuf@8-!ZJ07LeXDk*EUGE4D^*puc^jAYq__rkhfV8n)61ppqXye>`R3pUM~s^b zp}#McOdGZDAN}$*@2oMWGG{ixjHkQjJ>!>&vz{N%Z~Wot#5vDJmweiB?YhxCUpILC z=Q-ob*usso>#rKOI$A59ublKqP3JS$et*q)#yy^YyJFJg_8z(nH!d1{z0@=Q)dhn; z;WTD`nlVb>dgE)R=&Ipr_;oz%i&cEMM0 zD}UM;Zl3aAN`2P|O%={7-Zu>?>AT23&%I!r?4B=t>G}zyHS=x$&#^;Bam7b}o$_5U zl25;4`F(0=f|_Z;V_W-e@qv|Gwp8k=B!|vIqCoOHcI`F;J$d| z=_{nales!>HnnvLcaXGeMQ-!fuK>P7+!n=~X>#*t6a8HY_*OD~jDsvo|Fqb=${~Wd zvHTCW+&Y#k((R+;Rh*}>)>YNZZDaX}x214rjI(tww~c)f`9DPmsmVoKn?E0ulCsIx ta3)qR>5>LS#^Ucreate(cutsq,ntypes+1,ntypes+1,"snap:cutsq"); for (int i = 1; i <= ntypes; i++) { cut = 2.0*radelem[i]*rcutfac; - printf("cut: %f\n", cut); + //printf("cut: %f\n", cut); if (cut > cutmax) cutmax = cut; cutsq[i][i] = cut*cut; for (int j = i+1; j <= ntypes; j++) { @@ -204,7 +204,8 @@ ComputeSnap::ComputeSnap(LAMMPS *lmp, int narg, char **arg) : //size_array_rows = bik_rows+ndims_force*natoms+ndims_virial; dbirj_rows = ndims_force*natoms; size_array_rows = bik_rows+dbirj_rows+ndims_virial; - size_array_cols = nperdim*atom->ntypes+1; + if (dbirjflag) size_array_cols = nperdim; + else size_array_cols = nperdim*atom->ntypes+1; lastcol = size_array_cols-1; ndims_peratom = ndims_force; @@ -217,6 +218,7 @@ ComputeSnap::ComputeSnap(LAMMPS *lmp, int narg, char **arg) : ComputeSnap::~ComputeSnap() { + memory->destroy(snap); memory->destroy(snapall); memory->destroy(snap_peratom); @@ -233,12 +235,18 @@ ComputeSnap::~ComputeSnap() } if (dbirjflag){ - printf("dbirj_rows: %d\n", dbirj_rows); + //printf("dbirj_rows: %d\n", dbirj_rows); + //printf("----- destroy dbirj\n"); memory->destroy(dbirj); + //printf("----- 1-1-1-1-1-1\n"); memory->destroy(nneighs); + //printf("----- 2-1-1-1-1-1\n"); memory->destroy(neighsum); + //printf("----- 3-1-1-1-1-1\n"); memory->destroy(icounter); + //printf("----- 4-1-1-1-1-1\n"); memory->destroy(dbiri); + //printf("----- 5-1-1-1-1-1\n"); } } @@ -263,7 +271,8 @@ void ComputeSnap::init() snaptr->init(); // allocate memory for global array - printf("----- dbirjflag: %d\n", dbirjflag); + + //printf("----- dbirjflag: %d\n", dbirjflag); memory->create(snap,size_array_rows,size_array_cols, "snap:snap"); memory->create(snapall,size_array_rows,size_array_cols, @@ -279,7 +288,6 @@ void ComputeSnap::init() c_pe = modify->compute[ipe]; // add compute for reference virial tensor - std::string id_virial = std::string("snap_press"); std::string pcmd = id_virial + " all pressure NULL virial"; modify->add_compute(pcmd); @@ -304,13 +312,17 @@ void ComputeSnap::init_list(int /*id*/, NeighList *ptr) void ComputeSnap::compute_array() { + //printf(" -----2 dbirjflag: %d\n", dbirjflag); if (dbirjflag){ - printf("----- dbirjflag true.\n"); + //printf("----- dbirjflag true.\n"); get_dbirj_length(); - printf("----- got dbirj_length\n"); + //printf("----- got dbirj_length\n"); } + //else{ + // printf("----- dbirjflag false.\n"); + //} - printf("----- cutmax cutforce: %f %f\n", cutmax, force->pair->cutforce); + //printf("----- cutmax cutforce: %f %f\n", cutmax, force->pair->cutforce); //else{ int ntotal = atom->nlocal + atom->nghost; @@ -325,7 +337,7 @@ void ComputeSnap::compute_array() "snap:snap_peratom"); } // clear global array - printf("size_array_rows: %d\n", size_array_rows); + //printf("size_array_rows: %d\n", size_array_rows); for (int irow = 0; irow < size_array_rows; irow++){ for (int icoeff = 0; icoeff < size_array_cols; icoeff++){ //printf("%d %d\n", irow, icoeff); @@ -361,7 +373,7 @@ void ComputeSnap::compute_array() for (int ii = 0; ii < inum; ii++) { int irow = 0; if (bikflag) irow = atom->tag[ilist[ii] & NEIGHMASK]-1; - printf("----- i, itag: %d %d\n", ilist[ii] & NEIGHMASK, atom->tag[ilist[ii]]); + //printf("----- i, itag: %d %d\n", ilist[ii] & NEIGHMASK, atom->tag[ilist[ii]]); const int i = ilist[ii]; //printf("----- ii, i: %d %d\n", ii, i); //printf("----- mask[i] groupbit: %d %d\n", mask[i], groupbit); @@ -439,7 +451,7 @@ void ComputeSnap::compute_array() I think it only needs neighbor info, and then it goes from there. */ //printf("----- Derivative loop - looping over neighbors j.\n"); - printf("----- ninside: %d\n", ninside); // numneighs of I within cutoff + //printf("----- ninside: %d\n", ninside); // numneighs of I within cutoff for (int jj = 0; jj < ninside; jj++) { //printf("----- jj: %d\n", jj); const int j = snaptr->inside[jj]; @@ -456,7 +468,7 @@ void ComputeSnap::compute_array() //icounter[atom->tag[j]-1] += 1; if (dbirjflag){ dbirj_row_indx = 3*neighsum[atom->tag[j]-1] + 3*icounter[atom->tag[j]-1] ; // THIS IS WRONG, SEE NEXT VAR. - printf("jtag, icounter, dbirj_row_indx: %d, %d, %d %d %d\n", atom->tag[j], icounter[atom->tag[j]-1], dbirj_row_indx+0, dbirj_row_indx+1, dbirj_row_indx+2); + //printf("jtag, icounter, dbirj_row_indx: %d, %d, %d %d %d\n", atom->tag[j], icounter[atom->tag[j]-1], dbirj_row_indx+0, dbirj_row_indx+1, dbirj_row_indx+2); icounter[atom->tag[j]-1] += 1; } //int dbirj_row_indx = 3*neighsum[atom->tag[j]-1] + 3*icounter[atom->tag[j]-1] ; // THIS IS WRONG, SEE NEXT VAR. @@ -522,6 +534,7 @@ void ComputeSnap::compute_array() dbiri[3*(atom->tag[i]-1)+2][icoeff] -= snaptr->dblist[icoeff][2]; } + } if (quadraticflag) { @@ -579,10 +592,13 @@ void ComputeSnap::compute_array() //printf("----- Accumulate Bi.\n"); // linear contributions - - int k = typeoffset_global; - for (int icoeff = 0; icoeff < ncoeff; icoeff++) + int k; + if (dbirjflag) k = 0; + else k = typeoffset_global; + for (int icoeff = 0; icoeff < ncoeff; icoeff++){ + //printf("----- %d %f\n", icoeff, snaptr->blist[icoeff]); snap[irow][k++] += snaptr->blist[icoeff]; + } // quadratic contributions @@ -601,8 +617,8 @@ void ComputeSnap::compute_array() numneigh_sum += ninside; } // for (int ii = 0; ii < inum; ii++) - printf("----- bik_rows: %d\n", bik_rows); - printf("----- bikflag: %d\n", bikflag); + //printf("----- bik_rows: %d\n", bik_rows); + //printf("----- bikflag: %d\n", bikflag); // Check icounter. /* @@ -615,16 +631,19 @@ void ComputeSnap::compute_array() */ // Sum all the derivatives we calculated to check usual compute snap output. + /* if (dbirjflag){ fh_d = fopen("DEBUG", "w"); int row_indx=0; + double sum; for (int ii=0; iintypes); //for (int itype = 0; itype < atom->ntypes; itype++) { + int dbiri_indx; + int irow; for (int itype=0; itype<1; itype++){ const int typeoffset_local = ndims_peratom*nperdim*itype; const int typeoffset_global = nperdim*itype; //printf("----- nperdim: %d\n", nperdim); - /*nperdim = ncoeff set previsouly*/ for (int icoeff = 0; icoeff < nperdim; icoeff++) { //printf("----- icoeff: %d\n", icoeff); + dbiri_indx=0; for (int i = 0; i < atom->nlocal; i++) { //printf("i: %d\n", i); - + //int dbiri_indx = 0; + //int irow; for (int jj=0; jjtag[i]-1] + 3*jj; - int irow = dbirj_row_indx+bik_rows; + int snap_row_indx = 3*neighsum[atom->tag[i]-1] + 3*(atom->tag[i]-1) + 3*jj; + //printf("snap_row_indx: %d\n", snap_row_indx); + //int irow = dbirj_row_indx+bik_rows; + irow = snap_row_indx + bik_rows; //printf(" row_indx, irow: %d %d\n", dbirj_row_indx, irow); snap[irow++][icoeff+typeoffset_global] += dbirj[dbirj_row_indx+0][icoeff]; //printf(" irow: %d\n", irow); snap[irow++][icoeff+typeoffset_global] += dbirj[dbirj_row_indx+1][icoeff]; //printf(" irow: %d\n", irow); snap[irow][icoeff+typeoffset_global] += dbirj[dbirj_row_indx+2][icoeff]; + dbiri_indx = dbiri_indx+3; } + // Put dBi/dRi at end of each dBj/dRi chunk. + //int dbiri_row_indx; + irow = dbiri_indx + bik_rows; + //printf("dbiri_indx: %d\n", dbiri_indx); + //printf("dbiri: %f %f %f\n", dbiri[3*i+0][icoeff], dbiri[3*i+1][icoeff], dbiri[3*i+2][icoeff]); + snap[irow++][icoeff+typeoffset_global] += dbiri[3*i+0][icoeff]; + //printf(" irow: %d\n", irow); + snap[irow++][icoeff+typeoffset_global] += dbiri[3*i+1][icoeff]; + //printf(" irow: %d\n", irow); + snap[irow][icoeff+typeoffset_global] += dbiri[3*i+2][icoeff]; - - //int dbirj_row_indx = 3*neighsum[atom->tag[i]-1] + 3*icounter[atom->tag[i]-1]; - //printf(" row_indx: %d\n", dbirj_row_indx); - - /* - double *snadi = snap_peratom[i]+typeoffset_local; - int iglobal = atom->tag[i]; - if (icoeff==4){ - if ( (snadi[icoeff] != 0.0) || (snadi[icoeff+yoffset] != 0.0) || (snadi[icoeff+zoffset] != 0.0) ){ - //printf("%d %d %f %f %f\n", i, iglobal, snadi[icoeff], snadi[icoeff+yoffset], snadi[icoeff+zoffset]); - } - } - int irow = 3*(iglobal-1)+bik_rows; - //printf("----- snadi[icoeff]: %f\n", snadi[icoeff]); - snap[irow++][icoeff+typeoffset_global] += snadi[icoeff]; - snap[irow++][icoeff+typeoffset_global] += snadi[icoeff+yoffset]; - snap[irow][icoeff+typeoffset_global] += snadi[icoeff+zoffset]; - */ + dbiri_indx = dbiri_indx+3; } } } + //printf(" Accumulated to global array.\n"); } @@ -784,22 +774,26 @@ void ComputeSnap::compute_array() // accumulate bispectrum virial contributions to global array - dbdotr_compute(); + //dbdotr_compute(); // sum up over all processes -printf("`-`-`-` snap[50][6]: %f\n", snap[50][6]); -printf("`-`-`-` snapall[50][6]: %f\n", snapall[50][6]); MPI_Allreduce(&snap[0][0],&snapall[0][0],size_array_rows*size_array_cols,MPI_DOUBLE,MPI_SUM,world); // assign energy to last column - for (int i = 0; i < bik_rows; i++) snapall[i][lastcol] = 0; - int irow = 0; - double reference_energy = c_pe->compute_scalar(); - snapall[irow][lastcol] = reference_energy; + if (dbirjflag){ + + } + else{ + for (int i = 0; i < bik_rows; i++) snapall[i][lastcol] = 0; + int irow = 0; + double reference_energy = c_pe->compute_scalar(); + snapall[irow][lastcol] = reference_energy; + } // assign virial stress to last column // switch to Voigt notation c_virial->compute_vector(); + /* irow += 3*natoms+bik_rows; snapall[irow++][lastcol] = c_virial->vector[0]; snapall[irow++][lastcol] = c_virial->vector[1]; @@ -807,10 +801,9 @@ printf("`-`-`-` snapall[50][6]: %f\n", snapall[50][6]); snapall[irow++][lastcol] = c_virial->vector[5]; snapall[irow++][lastcol] = c_virial->vector[4]; snapall[irow][lastcol] = c_virial->vector[3]; + */ //}// else - - printf("----- End of compute_array.\n"); } /* ---------------------------------------------------------------------- @@ -824,7 +817,7 @@ void ComputeSnap::dbdotr_compute() int irow0; if (dbirjflag){ - irow0 = bik_rows+dbirj_rows; + irow0 = bik_rows+dbirj_rows+(3*natoms); } else{ irow0 = bik_rows+ndims_force*natoms; @@ -861,10 +854,11 @@ void ComputeSnap::dbdotr_compute() void ComputeSnap::get_dbirj_length() { + + memory->destroy(snap); + memory->destroy(snapall); // invoke full neighbor list (will copy or build if necessary) neighbor->build_one(list); - //memory->destroy(snap); - //memory->destroy(snapall); dbirj_rows = 0; const int inum = list->inum; const int* const ilist = list->ilist; @@ -877,8 +871,8 @@ void ComputeSnap::get_dbirj_length() memory->create(neighsum, inum, "snap:neighsum"); memory->create(nneighs, inum, "snap:nneighs"); memory->create(icounter, inum, "snap:icounter"); - memory->create(dbiri, 3*inum,ncoeff, "snap:dbiri"); - for (int ii=0; iicreate(dbiri, 3*atom->nlocal,ncoeff, "snap:dbiri"); + for (int ii=0; ii<3*atom->nlocal; ii++){ for (int icoeff=0; icoeffcreate(dbirj, dbirj_rows, ncoeff, "snap:dbirj"); + for (int i=0; inlocal; // Add 3*N for dBi/dRi //printf("----- dbirj_rows: %d\n", dbirj_rows); //printf("----- end of dbirj length.\n"); diff --git a/src/ML-SNAP/compute_snapneigh.cpp b/src/ML-SNAP/compute_snapneigh.cpp index dd6146e154..eef18a93f4 100644 --- a/src/ML-SNAP/compute_snapneigh.cpp +++ b/src/ML-SNAP/compute_snapneigh.cpp @@ -82,7 +82,7 @@ ComputeSnapneigh::ComputeSnapneigh(LAMMPS *lmp, int narg, char **arg) : memory->create(cutsq,ntypes+1,ntypes+1,"snapneigh:cutsq"); for (int i = 1; i <= ntypes; i++) { cut = 2.0*radelem[i]*rcutfac; - printf("cut: %f\n", cut); + //printf("cut: %f\n", cut); if (cut > cutmax) cutmax = cut; cutsq[i][i] = cut*cut; for (int j = i+1; j <= ntypes; j++) { @@ -235,12 +235,12 @@ ComputeSnapneigh::~ComputeSnapneigh() } if (dbirjflag){ - printf("dbirj_rows: %d\n", dbirj_rows); - memory->destroy(dbirj); + //printf("dbirj_rows: %d\n", dbirj_rows); + //memory->destroy(dbirj); memory->destroy(nneighs); memory->destroy(neighsum); memory->destroy(icounter); - memory->destroy(dbiri); + //memory->destroy(dbiri); } } @@ -276,12 +276,12 @@ void ComputeSnapneigh::compute_array() { if (dbirjflag){ - printf("----- dbirjflag true.\n"); + //printf("----- dbirjflag true.\n"); get_dbirj_length(); - printf("----- got dbirj_length\n"); + //printf("----- got dbirj_length\n"); } - printf("----- cutmax cutforce: %f %f\n", cutmax, force->pair->cutforce); + //printf("----- cutmax cutforce: %f %f\n", cutmax, force->pair->cutforce); //else{ int ntotal = atom->nlocal + atom->nghost; @@ -306,6 +306,7 @@ void ComputeSnapneigh::compute_array() int ninside; int numneigh_sum = 0; int dbirj_row_indx; + int dbiri_indx=0; for (int ii = 0; ii < inum; ii++) { int irow = 0; if (bikflag) irow = atom->tag[ilist[ii] & NEIGHMASK]-1; @@ -358,7 +359,10 @@ void ComputeSnapneigh::compute_array() jelem = map[jtype]; if (rsq < cutsq[itype][jtype]&&rsq>1e-20) { if (dbirjflag){ - dbirj_row_indx = 3*neighsum[atom->tag[j]-1] + 3*icounter[atom->tag[j]-1] ; // THIS IS WRONG, SEE NEXT VAR. + //dbirj_row_indx = 3*neighsum[atom->tag[j]-1] + 3*icounter[atom->tag[j]-1] ; // THIS IS WRONG, SEE NEXT VAR. + //dbirj_row_indx = 3*neighsum[atom->tag[i]-1] + 3*(atom->tag[i]-1) + 3*icounter[atom->tag[j]-1]; // 3*tagi is to leave space for dBi/dRi + dbirj_row_indx = 3*neighsum[atom->tag[j]-1] + 3*icounter[atom->tag[j]-1] + 3*(atom->tag[j]-1); // THIS IS WRONG, SEE NEXT VAR. + //printf("--- %d %d %d %d\n", dbirj_row_indx, 3*neighsum[atom->tag[i]-1], 3*(atom->tag[i]-1), jj); //printf("jtag, icounter, dbirj_row_indx: %d, %d, %d %d %d\n", atom->tag[j], icounter[atom->tag[j]-1], dbirj_row_indx+0, dbirj_row_indx+1, dbirj_row_indx+2); icounter[atom->tag[j]-1] += 1; @@ -369,13 +373,32 @@ void ComputeSnapneigh::compute_array() neighs[dbirj_row_indx+0][1] = atom->tag[j]; neighs[dbirj_row_indx+1][1] = atom->tag[j]; neighs[dbirj_row_indx+2][1] = atom->tag[j]; + + neighs[dbirj_row_indx+0][2] = 0; + neighs[dbirj_row_indx+1][2] = 1; + neighs[dbirj_row_indx+2][2] = 2; + + dbiri_indx = dbiri_indx+3; } } } - // for (int jj = 0; jj < ninside; jj++) - //printf("---- irow after jj loop: %d\n", irow); + //printf("--- dbiri_indx: %d\n", dbiri_indx); + // Put dBi/dRi in + neighs[dbiri_indx+0][0] = atom->tag[i]; + neighs[dbiri_indx+1][0] = atom->tag[i]; + neighs[dbiri_indx+2][0] = atom->tag[i]; + + neighs[dbiri_indx+0][1] = atom->tag[i]; + neighs[dbiri_indx+1][1] = atom->tag[i]; + neighs[dbiri_indx+2][1] = atom->tag[i]; + + neighs[dbiri_indx+0][2] = 0; + neighs[dbiri_indx+1][2] = 1; + neighs[dbiri_indx+2][2] = 2; + + dbiri_indx = dbiri_indx+3; } numneigh_sum += ninside; @@ -404,14 +427,14 @@ void ComputeSnapneigh::compute_array() snapall[irow][lastcol] = reference_energy; */ - + /* for (int i=0; imask; double** const x = atom->x; //printf("----- inum: %d\n", inum); - memory->create(neighsum, inum, "snapneigh:neighsum"); - memory->create(nneighs, inum, "snapneigh:nneighs"); - memory->create(icounter, inum, "snapneigh:icounter"); - memory->create(dbiri, 3*inum,ncoeff, "snapneigh:dbiri"); + memory->create(neighsum, atom->nlocal, "snapneigh:neighsum"); + memory->create(nneighs, atom->nlocal, "snapneigh:nneighs"); + memory->create(icounter, atom->nlocal, "snapneigh:icounter"); + //memory->create(dbiri, 3*inum,ncoeff, "snapneigh:dbiri"); + /* for (int ii=0; iicreate(dbirj, dbirj_rows, ncoeff, "snapneigh:dbirj"); - memory->create(neighs, dbirj_rows, 2, "snapneigh:neighs"); - size_array_rows = dbirj_rows; - size_array_cols = 2; + size_array_rows = dbirj_rows+(3*atom->nlocal); + size_array_cols = 3; + //memory->create(dbirj, dbirj_rows, ncoeff, "snapneigh:dbirj"); + memory->create(neighs, size_array_rows, size_array_cols, "snapneigh:neighs"); + //vector = neighs; array = neighs; // Set size array rows which now depends on dbirj_rows. From 5c68fe6e8154765772e7f3e81cafa7a389cca08c Mon Sep 17 00:00:00 2001 From: Stan Moore Date: Mon, 6 Jun 2022 15:15:47 -0700 Subject: [PATCH 317/585] Fix issues in compute ave/sphere/atom --- doc/src/compute_ave_sphere_atom.rst | 6 ++-- src/EXTRA-COMPUTE/compute_ave_sphere_atom.cpp | 31 ++++++++++++++++--- src/EXTRA-COMPUTE/compute_ave_sphere_atom.h | 2 +- src/KOKKOS/compute_ave_sphere_atom_kokkos.cpp | 28 ++++++++++++++--- src/KOKKOS/compute_ave_sphere_atom_kokkos.h | 13 +++++--- 5 files changed, 62 insertions(+), 18 deletions(-) diff --git a/doc/src/compute_ave_sphere_atom.rst b/doc/src/compute_ave_sphere_atom.rst index db04682865..0cf631a941 100644 --- a/doc/src/compute_ave_sphere_atom.rst +++ b/doc/src/compute_ave_sphere_atom.rst @@ -35,7 +35,7 @@ Examples Description """"""""""" -Define a computation that calculates the local density and temperature +Define a computation that calculates the local mass density and temperature for each atom and neighbors inside a spherical cutoff. The optional keyword *cutoff* defines the distance cutoff @@ -58,7 +58,7 @@ too frequently. interactions between atoms in the same bond, angle, or dihedral. This is the default setting for the :doc:`special_bonds ` command, and means those pairwise interactions do not appear in the - neighbor list. Because this fix uses the neighbor list, it also means + neighbor list. Because this compute uses the neighbor list, it also means those pairs will not be included in the order parameter. This difficulty can be circumvented by writing a dump file, and using the :doc:`rerun ` command to compute the order parameter for @@ -77,7 +77,7 @@ too frequently. Output info """"""""""" -This compute calculates a per-atom array with two columns: density and temperature. +This compute calculates a per-atom array with two columns: mass density and temperature. These values can be accessed by any command that uses per-atom values from a compute as input. See the :doc:`Howto output ` doc diff --git a/src/EXTRA-COMPUTE/compute_ave_sphere_atom.cpp b/src/EXTRA-COMPUTE/compute_ave_sphere_atom.cpp index 07803aca20..b63c5c2b07 100644 --- a/src/EXTRA-COMPUTE/compute_ave_sphere_atom.cpp +++ b/src/EXTRA-COMPUTE/compute_ave_sphere_atom.cpp @@ -15,6 +15,7 @@ #include "atom.h" #include "comm.h" +#include "domain.h" #include "error.h" #include "force.h" #include "math_const.h" @@ -98,7 +99,10 @@ void ComputeAveSphereAtom::init() } cutsq = cutoff * cutoff; - sphere_vol = 4.0 / 3.0 * MY_PI * cutsq * cutoff; + if (domain->dimension == 3) + volume = 4.0 / 3.0 * MY_PI * cutsq * cutoff; + else + volume = MY_PI * cutsq; // need an occasional full neighbor list @@ -152,12 +156,25 @@ void ComputeAveSphereAtom::compute_peratom() double **x = atom->x; double **v = atom->v; + double *mass = atom->mass; + double *rmass = atom->rmass; + int *type = atom->type; int *mask = atom->mask; + double massone_i,massone_j; + double totalmass = 0.0; + + double adof = domain->dimension; + double mvv2e = force->mvv2e; + double mv2d = force->mv2d; + double boltz = force->boltz; for (ii = 0; ii < inum; ii++) { i = ilist[ii]; if (mask[i] & groupbit) { + if (rmass) massone_i = rmass[i]; + else massone_i = mass[type[i]]; + xtmp = x[i][0]; ytmp = x[i][1]; ztmp = x[i][2]; @@ -174,6 +191,8 @@ void ComputeAveSphereAtom::compute_peratom() for (jj = 0; jj < jnum; jj++) { j = jlist[jj]; j &= NEIGHMASK; + if (rmass) massone_j = rmass[i]; + else massone_j = mass[type[i]]; delx = xtmp - x[j][0]; dely = ytmp - x[j][1]; @@ -194,10 +213,11 @@ void ComputeAveSphereAtom::compute_peratom() // i atom contribution count = 1; + totalmass = massone_i; vnet[0] = v[i][0] - vavg[0]; vnet[1] = v[i][1] - vavg[1]; vnet[2] = v[i][2] - vavg[2]; - double ke_sum = vnet[0] * vnet[0] + vnet[1] * vnet[1] + vnet[2] * vnet[2]; + double ke_sum = massone_i * (vnet[0] * vnet[0] + vnet[1] * vnet[1] + vnet[2] * vnet[2]); for (jj = 0; jj < jnum; jj++) { j = jlist[jj]; @@ -209,14 +229,15 @@ void ComputeAveSphereAtom::compute_peratom() rsq = delx * delx + dely * dely + delz * delz; if (rsq < cutsq) { count++; + totalmass += massone_j; vnet[0] = v[j][0] - vavg[0]; vnet[1] = v[j][1] - vavg[1]; vnet[2] = v[j][2] - vavg[2]; - ke_sum += vnet[0] * vnet[0] + vnet[1] * vnet[1] + vnet[2] * vnet[2]; + ke_sum += massone_j * (vnet[0] * vnet[0] + vnet[1] * vnet[1] + vnet[2] * vnet[2]); } } - double density = count / sphere_vol; - double temp = ke_sum / 3.0 / count; + double density = mv2d * totalmass / volume; + double temp = mvv2e * ke_sum / (adof * count * boltz); result[i][0] = density; result[i][1] = temp; } diff --git a/src/EXTRA-COMPUTE/compute_ave_sphere_atom.h b/src/EXTRA-COMPUTE/compute_ave_sphere_atom.h index ffed09bae5..76350997f9 100644 --- a/src/EXTRA-COMPUTE/compute_ave_sphere_atom.h +++ b/src/EXTRA-COMPUTE/compute_ave_sphere_atom.h @@ -37,7 +37,7 @@ class ComputeAveSphereAtom : public Compute { protected: int nmax; - double cutoff, cutsq, sphere_vol; + double cutoff, cutsq, volume; class NeighList *list; double **result; diff --git a/src/KOKKOS/compute_ave_sphere_atom_kokkos.cpp b/src/KOKKOS/compute_ave_sphere_atom_kokkos.cpp index d2cb6682a7..df70a27738 100644 --- a/src/KOKKOS/compute_ave_sphere_atom_kokkos.cpp +++ b/src/KOKKOS/compute_ave_sphere_atom_kokkos.cpp @@ -16,6 +16,7 @@ #include "atom_kokkos.h" #include "atom_masks.h" #include "comm.h" +#include "domain.h" #include "error.h" #include "force.h" #include "memory_kokkos.h" @@ -105,11 +106,19 @@ void ComputeAveSphereAtomKokkos::compute_peratom() // compute properties for each atom in group // use full neighbor list to count atoms less than cutoff - atomKK->sync(execution_space,X_MASK|V_MASK|TYPE_MASK|MASK_MASK); + atomKK->sync(execution_space,X_MASK|V_MASK|RMASS_MASK|TYPE_MASK|MASK_MASK); x = atomKK->k_x.view(); v = atomKK->k_v.view(); + rmass = atomKK->k_rmass.view(); + mass = atomKK->k_mass.view(); + type = atomKK->k_type.view(); mask = atomKK->k_mask.view(); + adof = domain->dimension; + mvv2e = force->mvv2e; + mv2d = force->mv2d; + boltz = force->boltz; + Kokkos::deep_copy(d_result,0.0); copymode = 1; @@ -125,8 +134,13 @@ template KOKKOS_INLINE_FUNCTION void ComputeAveSphereAtomKokkos::operator()(TagComputeAveSphereAtom, const int &ii) const { + double massone_i,massone_j,totalmass; + const int i = d_ilist[ii]; if (mask[i] & groupbit) { + if (rmass.data()) massone_i = rmass[i]; + else massone_i = mass[type[i]]; + const X_FLOAT xtmp = x(i,0); const X_FLOAT ytmp = x(i,1); const X_FLOAT ztmp = x(i,2); @@ -164,15 +178,18 @@ void ComputeAveSphereAtomKokkos::operator()(TagComputeAveSphereAtom, // i atom contribution count = 1; + totalmass = massone_i; double vnet[3]; vnet[0] = v(i,0) - vavg[0]; vnet[1] = v(i,1) - vavg[1]; vnet[2] = v(i,2) - vavg[2]; - double ke_sum = vnet[0]*vnet[0] + vnet[1]*vnet[1] + vnet[2]*vnet[2]; + double ke_sum = massone_i * (vnet[0]*vnet[0] + vnet[1]*vnet[1] + vnet[2]*vnet[2]); for (int jj = 0; jj < jnum; jj++) { int j = d_neighbors(i,jj); j &= NEIGHMASK; + if (rmass.data()) massone_j = rmass[i]; + else massone_j = mass[type[i]]; const F_FLOAT delx = x(j,0) - xtmp; const F_FLOAT dely = x(j,1) - ytmp; @@ -180,14 +197,15 @@ void ComputeAveSphereAtomKokkos::operator()(TagComputeAveSphereAtom, const F_FLOAT rsq = delx*delx + dely*dely + delz*delz; if (rsq < cutsq) { count++; + totalmass += massone_j; vnet[0] = v(j,0) - vavg[0]; vnet[1] = v(j,1) - vavg[1]; vnet[2] = v(j,2) - vavg[2]; - ke_sum += vnet[0]*vnet[0] + vnet[1]*vnet[1] + vnet[2]*vnet[2]; + ke_sum += massone_j * (vnet[0]*vnet[0] + vnet[1]*vnet[1] + vnet[2]*vnet[2]); } } - double density = count/sphere_vol; - double temp = ke_sum/3.0/count; + double density = mv2d*totalmass/volume; + double temp = mvv2e*ke_sum/(adof*count*boltz); d_result(i,0) = density; d_result(i,1) = temp; } diff --git a/src/KOKKOS/compute_ave_sphere_atom_kokkos.h b/src/KOKKOS/compute_ave_sphere_atom_kokkos.h index 75b5ca3aba..1ddf943e7d 100644 --- a/src/KOKKOS/compute_ave_sphere_atom_kokkos.h +++ b/src/KOKKOS/compute_ave_sphere_atom_kokkos.h @@ -46,13 +46,18 @@ template class ComputeAveSphereAtomKokkos : public ComputeAve void operator()(TagComputeAveSphereAtom, const int &) const; private: - typename AT::t_x_array_randomread x; - typename AT::t_v_array_randomread v; + double adof,mvv2e,mv2d,boltz; + + typename AT::t_x_array x; + typename AT::t_v_array v; + typename ArrayTypes::t_float_1d rmass; + typename ArrayTypes::t_float_1d mass; + typename ArrayTypes::t_int_1d type; typename ArrayTypes::t_int_1d mask; typename AT::t_neighbors_2d d_neighbors; - typename AT::t_int_1d_randomread d_ilist; - typename AT::t_int_1d_randomread d_numneigh; + typename AT::t_int_1d d_ilist; + typename AT::t_int_1d d_numneigh; DAT::tdual_float_2d k_result; typename AT::t_float_2d d_result; From 7e77b61042c09ba47c88f4983d0505f39b74f10e Mon Sep 17 00:00:00 2001 From: Stan Moore Date: Mon, 6 Jun 2022 15:23:03 -0700 Subject: [PATCH 318/585] simplify --- src/EXTRA-COMPUTE/compute_ave_sphere_atom.cpp | 3 +-- 1 file changed, 1 insertion(+), 2 deletions(-) diff --git a/src/EXTRA-COMPUTE/compute_ave_sphere_atom.cpp b/src/EXTRA-COMPUTE/compute_ave_sphere_atom.cpp index b63c5c2b07..f299305cf3 100644 --- a/src/EXTRA-COMPUTE/compute_ave_sphere_atom.cpp +++ b/src/EXTRA-COMPUTE/compute_ave_sphere_atom.cpp @@ -160,8 +160,7 @@ void ComputeAveSphereAtom::compute_peratom() double *rmass = atom->rmass; int *type = atom->type; int *mask = atom->mask; - double massone_i,massone_j; - double totalmass = 0.0; + double massone_i,massone_j,totalmass; double adof = domain->dimension; double mvv2e = force->mvv2e; From 67d367e714082941c55f6b547e6b1e2352626031 Mon Sep 17 00:00:00 2001 From: Stan Moore Date: Mon, 6 Jun 2022 15:28:40 -0700 Subject: [PATCH 319/585] Fix copy/paste bug --- src/EXTRA-COMPUTE/compute_ave_sphere_atom.cpp | 4 ++-- src/KOKKOS/compute_ave_sphere_atom_kokkos.cpp | 4 ++-- 2 files changed, 4 insertions(+), 4 deletions(-) diff --git a/src/EXTRA-COMPUTE/compute_ave_sphere_atom.cpp b/src/EXTRA-COMPUTE/compute_ave_sphere_atom.cpp index f299305cf3..4409fbb502 100644 --- a/src/EXTRA-COMPUTE/compute_ave_sphere_atom.cpp +++ b/src/EXTRA-COMPUTE/compute_ave_sphere_atom.cpp @@ -190,8 +190,8 @@ void ComputeAveSphereAtom::compute_peratom() for (jj = 0; jj < jnum; jj++) { j = jlist[jj]; j &= NEIGHMASK; - if (rmass) massone_j = rmass[i]; - else massone_j = mass[type[i]]; + if (rmass) massone_j = rmass[j]; + else massone_j = mass[type[j]]; delx = xtmp - x[j][0]; dely = ytmp - x[j][1]; diff --git a/src/KOKKOS/compute_ave_sphere_atom_kokkos.cpp b/src/KOKKOS/compute_ave_sphere_atom_kokkos.cpp index df70a27738..ed54a92f63 100644 --- a/src/KOKKOS/compute_ave_sphere_atom_kokkos.cpp +++ b/src/KOKKOS/compute_ave_sphere_atom_kokkos.cpp @@ -188,8 +188,8 @@ void ComputeAveSphereAtomKokkos::operator()(TagComputeAveSphereAtom, for (int jj = 0; jj < jnum; jj++) { int j = d_neighbors(i,jj); j &= NEIGHMASK; - if (rmass.data()) massone_j = rmass[i]; - else massone_j = mass[type[i]]; + if (rmass.data()) massone_j = rmass[j]; + else massone_j = mass[type[j]]; const F_FLOAT delx = x(j,0) - xtmp; const F_FLOAT dely = x(j,1) - ytmp; From 880382e26ad3988b41c601c7d03e776599a55534 Mon Sep 17 00:00:00 2001 From: rohskopf Date: Mon, 6 Jun 2022 17:43:47 -0600 Subject: [PATCH 320/585] Compute snap array contains force indices in last columns. --- src/ML-SNAP/compute_snap.cpp | 80 ++++++++++++++++++++++++++++++++---- 1 file changed, 72 insertions(+), 8 deletions(-) diff --git a/src/ML-SNAP/compute_snap.cpp b/src/ML-SNAP/compute_snap.cpp index be06df4b68..b40d86546b 100644 --- a/src/ML-SNAP/compute_snap.cpp +++ b/src/ML-SNAP/compute_snap.cpp @@ -204,7 +204,7 @@ ComputeSnap::ComputeSnap(LAMMPS *lmp, int narg, char **arg) : //size_array_rows = bik_rows+ndims_force*natoms+ndims_virial; dbirj_rows = ndims_force*natoms; size_array_rows = bik_rows+dbirj_rows+ndims_virial; - if (dbirjflag) size_array_cols = nperdim; + if (dbirjflag) size_array_cols = nperdim+3; // plus 3 for tag[i], tag[2], and cartesian index else size_array_cols = nperdim*atom->ntypes+1; lastcol = size_array_cols-1; @@ -528,10 +528,35 @@ void ComputeSnap::compute_array() dbirj[dbirj_row_indx+0][icoeff] = snaptr->dblist[icoeff][0]; dbirj[dbirj_row_indx+1][icoeff] = snaptr->dblist[icoeff][1]; dbirj[dbirj_row_indx+2][icoeff] = snaptr->dblist[icoeff][2]; + if (icoeff==(ncoeff-1)){ + dbirj[dbirj_row_indx+0][ncoeff] = atom->tag[i]; + dbirj[dbirj_row_indx+0][ncoeff+1] = atom->tag[j]; + dbirj[dbirj_row_indx+0][ncoeff+2] = 0; + dbirj[dbirj_row_indx+1][ncoeff] = atom->tag[i]; + dbirj[dbirj_row_indx+1][ncoeff+1] = atom->tag[j]; + dbirj[dbirj_row_indx+1][ncoeff+2] = 1; + dbirj[dbirj_row_indx+2][ncoeff] = atom->tag[i]; + dbirj[dbirj_row_indx+2][ncoeff+1] = atom->tag[j]; + dbirj[dbirj_row_indx+2][ncoeff+2] = 2; + } // Accumulate dBi/dRi = sum (-dBi/dRj) for neighbors j of if i. dbiri[3*(atom->tag[i]-1)+0][icoeff] -= snaptr->dblist[icoeff][0]; dbiri[3*(atom->tag[i]-1)+1][icoeff] -= snaptr->dblist[icoeff][1]; dbiri[3*(atom->tag[i]-1)+2][icoeff] -= snaptr->dblist[icoeff][2]; + // Get last columns + if (icoeff==(ncoeff-1)){ + dbiri[3*(atom->tag[i]-1)+0][ncoeff] = atom->tag[i]; + dbiri[3*(atom->tag[i]-1)+0][ncoeff+1] = atom->tag[i]; + dbiri[3*(atom->tag[i]-1)+0][ncoeff+2] = 0; + + dbiri[3*(atom->tag[i]-1)+1][ncoeff] = atom->tag[i]; + dbiri[3*(atom->tag[i]-1)+1][ncoeff+1] = atom->tag[i]; + dbiri[3*(atom->tag[i]-1)+1][ncoeff+2] = 1; + + dbiri[3*(atom->tag[i]-1)+2][ncoeff] = atom->tag[i]; + dbiri[3*(atom->tag[i]-1)+2][ncoeff+1] = atom->tag[i]; + dbiri[3*(atom->tag[i]-1)+2][ncoeff+2] = 2; + } } @@ -696,11 +721,31 @@ void ComputeSnap::compute_array() //int irow = dbirj_row_indx+bik_rows; irow = snap_row_indx + bik_rows; //printf(" row_indx, irow: %d %d\n", dbirj_row_indx, irow); - snap[irow++][icoeff+typeoffset_global] += dbirj[dbirj_row_indx+0][icoeff]; + // x-coordinate + snap[irow][icoeff+typeoffset_global] += dbirj[dbirj_row_indx+0][icoeff]; + if (icoeff==(ncoeff-1)){ + snap[irow][ncoeff] += dbirj[dbirj_row_indx+0][ncoeff]; + snap[irow][ncoeff+1] += dbirj[dbirj_row_indx+0][ncoeff+1]; + snap[irow][ncoeff+2] += dbirj[dbirj_row_indx+0][ncoeff+2]; + } + irow++; //printf(" irow: %d\n", irow); - snap[irow++][icoeff+typeoffset_global] += dbirj[dbirj_row_indx+1][icoeff]; + // y-coordinate + snap[irow][icoeff+typeoffset_global] += dbirj[dbirj_row_indx+1][icoeff]; + if (icoeff==(ncoeff-1)){ + snap[irow][ncoeff] += dbirj[dbirj_row_indx+1][ncoeff]; + snap[irow][ncoeff+1] += dbirj[dbirj_row_indx+1][ncoeff+1]; + snap[irow][ncoeff+2] += dbirj[dbirj_row_indx+1][ncoeff+2]; + } + irow++; //printf(" irow: %d\n", irow); + // z-coordinate snap[irow][icoeff+typeoffset_global] += dbirj[dbirj_row_indx+2][icoeff]; + if (icoeff==(ncoeff-1)){ + snap[irow][ncoeff] += dbirj[dbirj_row_indx+2][ncoeff]; + snap[irow][ncoeff+1] += dbirj[dbirj_row_indx+2][ncoeff+1]; + snap[irow][ncoeff+2] += dbirj[dbirj_row_indx+2][ncoeff+2]; + } dbiri_indx = dbiri_indx+3; } // Put dBi/dRi at end of each dBj/dRi chunk. @@ -708,11 +753,30 @@ void ComputeSnap::compute_array() irow = dbiri_indx + bik_rows; //printf("dbiri_indx: %d\n", dbiri_indx); //printf("dbiri: %f %f %f\n", dbiri[3*i+0][icoeff], dbiri[3*i+1][icoeff], dbiri[3*i+2][icoeff]); - snap[irow++][icoeff+typeoffset_global] += dbiri[3*i+0][icoeff]; + // x-coordinate + snap[irow][icoeff+typeoffset_global] += dbiri[3*i+0][icoeff]; + if (icoeff==(ncoeff-1)){ + snap[irow][ncoeff] += dbiri[3*i+0][ncoeff]; + snap[irow][ncoeff+1] += dbiri[3*i+0][ncoeff+1]; + snap[irow][ncoeff+2] += dbiri[3*i+0][ncoeff+2]; + } + irow++; //printf(" irow: %d\n", irow); - snap[irow++][icoeff+typeoffset_global] += dbiri[3*i+1][icoeff]; + // y-coordinate + snap[irow][icoeff+typeoffset_global] += dbiri[3*i+1][icoeff]; + if (icoeff==(ncoeff-1)){ + snap[irow][ncoeff] += dbiri[3*i+1][ncoeff]; + snap[irow][ncoeff+1] += dbiri[3*i+1][ncoeff+1]; + snap[irow][ncoeff+2] += dbiri[3*i+1][ncoeff+2]; + } + irow++; //printf(" irow: %d\n", irow); snap[irow][icoeff+typeoffset_global] += dbiri[3*i+2][icoeff]; + if (icoeff==(ncoeff-1)){ + snap[irow][ncoeff] += dbiri[3*i+2][ncoeff]; + snap[irow][ncoeff+1] += dbiri[3*i+2][ncoeff+1]; + snap[irow][ncoeff+2] += dbiri[3*i+2][ncoeff+2]; + } dbiri_indx = dbiri_indx+3; } @@ -871,7 +935,7 @@ void ComputeSnap::get_dbirj_length() memory->create(neighsum, inum, "snap:neighsum"); memory->create(nneighs, inum, "snap:nneighs"); memory->create(icounter, inum, "snap:icounter"); - memory->create(dbiri, 3*atom->nlocal,ncoeff, "snap:dbiri"); + memory->create(dbiri, 3*atom->nlocal,ncoeff+3, "snap:dbiri"); for (int ii=0; ii<3*atom->nlocal; ii++){ for (int icoeff=0; icoeffcreate(dbirj, dbirj_rows, ncoeff, "snap:dbirj"); + memory->create(dbirj, dbirj_rows, ncoeff+3, "snap:dbirj"); for (int i=0; i Date: Mon, 6 Jun 2022 21:39:10 -0400 Subject: [PATCH 321/585] apply clang-format --- src/EXTRA-COMPUTE/compute_ave_sphere_atom.cpp | 14 +++++++++----- 1 file changed, 9 insertions(+), 5 deletions(-) diff --git a/src/EXTRA-COMPUTE/compute_ave_sphere_atom.cpp b/src/EXTRA-COMPUTE/compute_ave_sphere_atom.cpp index 4409fbb502..45cab08329 100644 --- a/src/EXTRA-COMPUTE/compute_ave_sphere_atom.cpp +++ b/src/EXTRA-COMPUTE/compute_ave_sphere_atom.cpp @@ -160,7 +160,7 @@ void ComputeAveSphereAtom::compute_peratom() double *rmass = atom->rmass; int *type = atom->type; int *mask = atom->mask; - double massone_i,massone_j,totalmass; + double massone_i, massone_j, totalmass; double adof = domain->dimension; double mvv2e = force->mvv2e; @@ -171,8 +171,10 @@ void ComputeAveSphereAtom::compute_peratom() i = ilist[ii]; if (mask[i] & groupbit) { - if (rmass) massone_i = rmass[i]; - else massone_i = mass[type[i]]; + if (rmass) + massone_i = rmass[i]; + else + massone_i = mass[type[i]]; xtmp = x[i][0]; ytmp = x[i][1]; @@ -190,8 +192,10 @@ void ComputeAveSphereAtom::compute_peratom() for (jj = 0; jj < jnum; jj++) { j = jlist[jj]; j &= NEIGHMASK; - if (rmass) massone_j = rmass[j]; - else massone_j = mass[type[j]]; + if (rmass) + massone_j = rmass[j]; + else + massone_j = mass[type[j]]; delx = xtmp - x[j][0]; dely = ytmp - x[j][1]; From d7680dd7852901cf690b3c39472ffa71bb54c824 Mon Sep 17 00:00:00 2001 From: Stan Gerald Moore Date: Tue, 7 Jun 2022 10:10:03 -0600 Subject: [PATCH 322/585] Fix int32 overflow in Kokkos ReaxFF --- src/KOKKOS/pair_reaxff_kokkos.cpp | 2 +- src/KOKKOS/pair_reaxff_kokkos.h | 2 +- 2 files changed, 2 insertions(+), 2 deletions(-) diff --git a/src/KOKKOS/pair_reaxff_kokkos.cpp b/src/KOKKOS/pair_reaxff_kokkos.cpp index 7f2477adba..bb6ee0c1f1 100644 --- a/src/KOKKOS/pair_reaxff_kokkos.cpp +++ b/src/KOKKOS/pair_reaxff_kokkos.cpp @@ -2628,7 +2628,7 @@ int PairReaxFFKokkos::preprocess_angular(int i, int itype, int j_sta template template KOKKOS_INLINE_FUNCTION -int PairReaxFFKokkos::preprocess_torsion(int i, int /*itype*/, int itag, +int PairReaxFFKokkos::preprocess_torsion(int i, int /*itype*/, tagint itag, F_FLOAT xtmp, F_FLOAT ytmp, F_FLOAT ztmp, int j_start, int j_end, int location_torsion) const { // in reaxff_torsion_angles: j = i, k = j, i = k; diff --git a/src/KOKKOS/pair_reaxff_kokkos.h b/src/KOKKOS/pair_reaxff_kokkos.h index 39b323a0fe..836a2de731 100644 --- a/src/KOKKOS/pair_reaxff_kokkos.h +++ b/src/KOKKOS/pair_reaxff_kokkos.h @@ -257,7 +257,7 @@ class PairReaxFFKokkos : public PairReaxFF { // Abstraction for counting and populating torsion intermediated template KOKKOS_INLINE_FUNCTION - int preprocess_torsion(int, int, int, F_FLOAT, F_FLOAT, F_FLOAT, int, int, int) const; + int preprocess_torsion(int, int, tagint, F_FLOAT, F_FLOAT, F_FLOAT, int, int, int) const; template KOKKOS_INLINE_FUNCTION From 42694ba6406245ae0a66ec74c814f445224b997c Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 7 Jun 2022 19:39:36 -0400 Subject: [PATCH 323/585] reduce warnings when compiling with KOKKOS --- src/fmt/core.h | 4 +++- 1 file changed, 3 insertions(+), 1 deletion(-) diff --git a/src/fmt/core.h b/src/fmt/core.h index 8444cd9546..2fafa777ba 100644 --- a/src/fmt/core.h +++ b/src/fmt/core.h @@ -315,7 +315,9 @@ // Enable minimal optimizations for more compact code in debug mode. FMT_GCC_PRAGMA("GCC push_options") -#ifndef __OPTIMIZE__ +// LAMMPS CUSTOMIZATION: suppress warning about pragma with KOKKOS +#if !defined(__OPTIMIZE__) && !defined(LMP_KOKKOS) +// END LAMMPS CUSTOMIZATION FMT_GCC_PRAGMA("GCC optimize(\"Og\")") #endif From 55fdb7f12a4a4b6f3a291f0d34b57ab391722245 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 8 Jun 2022 08:19:54 -0400 Subject: [PATCH 324/585] update GPU container definitions for CUDA 11.7 and singularity -> apptainer --- doc/src/Tools.rst | 17 +++++++++-------- tools/singularity/README.md | 10 ++++++---- tools/singularity/ubuntu18.04_gpu.def | 14 +++++++------- tools/singularity/ubuntu20.04_gpu.def | 12 ++++++------ 4 files changed, 28 insertions(+), 25 deletions(-) diff --git a/doc/src/Tools.rst b/doc/src/Tools.rst index ef403daa84..b57c91ffee 100644 --- a/doc/src/Tools.rst +++ b/doc/src/Tools.rst @@ -95,7 +95,7 @@ Miscellaneous tools * :ref:`LAMMPS shell ` * :ref:`LAMMPS magic patterns for file(1) ` * :ref:`Offline build tool ` - * :ref:`singularity ` + * :ref:`singularity/apptainer ` * :ref:`SWIG interface ` * :ref:`vim ` @@ -1007,14 +1007,15 @@ Ivanov, at University of Iceland (ali5 at hi.is). .. _singularity_tool: -singularity tool ----------------------------------------- +singularity/apptainer tool +-------------------------- -The singularity sub-directory contains container definitions files -that can be used to build container images for building and testing -LAMMPS on specific OS variants using the `Singularity `_ -container software. Contributions for additional variants are welcome. -For more details please see the README.md file in that folder. +The singularity sub-directory contains container definitions files that +can be used to build container images for building and testing LAMMPS on +specific OS variants using the `Apptainer `_ or +`Singularity `_ container software. Contributions for +additional variants are welcome. For more details please see the +README.md file in that folder. ---------- diff --git a/tools/singularity/README.md b/tools/singularity/README.md index db7aa9e3b0..4700dac6ec 100644 --- a/tools/singularity/README.md +++ b/tools/singularity/README.md @@ -1,17 +1,19 @@ -# Singularity container definitions for compiling/testing LAMMPS +# Apptainer (aka Singularity) container definitions for compiling/testing LAMMPS The *.def files in this folder can be used to build container images -for [Singularity](https://sylabs.io), suitable for compiling and testing +for [Apptainer](https://apptainer.org) (previously called +[Singularity](https://sylabs.io)), suitable for compiling and testing LAMMPS on a variety of OS variants with support for most standard packages and - for some of them - also building/spellchecking the manual -in all supported formats. This allows to test and debug LAMMPS code on +in all supported formats. This allows to test and debug LAMMPS code on different OS variants without doing a full installation on your development workstation, e.g. when bugs are reported that can only be reproduced on a specific OS or with specific (mostly older) versions of tools, compilers, or libraries. Here is a workflow for testing a compilation of LAMMPS with a locally -built CentOS 7.x singularity container. +built CentOS 7.x Singularity container. For Apptainer replace the +`singularity` command with `apptainer`. ``` cd some/work/directory diff --git a/tools/singularity/ubuntu18.04_gpu.def b/tools/singularity/ubuntu18.04_gpu.def index 6aa37ccf84..fac27dc7f3 100644 --- a/tools/singularity/ubuntu18.04_gpu.def +++ b/tools/singularity/ubuntu18.04_gpu.def @@ -2,11 +2,11 @@ BootStrap: docker From: ubuntu:18.04 %environment - export PATH=/usr/lib/ccache:/usr/local/cuda-11.5/bin:${PATH}:/opt/rocm/bin:/opt/rocm/profiler/bin:/opt/rocm/opencl/bin/x86_64 - export CUDADIR=/usr/local/cuda-11.5 - export CUDA_PATH=/usr/local/cuda-11.5 - export LD_LIBRARY_PATH=$LD_LIBRARY_PATH:/usr/local/cuda-11.5/lib64:/opt/rocm/lib:/opt/rocm-4.5.0/llvm/lib - export LIBRARY_PATH=/usr/local/cuda-11.5/lib64/stubs + export PATH=/usr/lib/ccache:/usr/local/cuda-11.7/bin:${PATH}:/opt/rocm/bin:/opt/rocm/profiler/bin:/opt/rocm/opencl/bin/x86_64 + export CUDADIR=/usr/local/cuda-11.7 + export CUDA_PATH=/usr/local/cuda-11.7 + export LD_LIBRARY_PATH=$LD_LIBRARY_PATH:/usr/local/cuda-11.7/lib64:/opt/rocm/lib:/opt/rocm-4.5.0/llvm/lib + export LIBRARY_PATH=/usr/local/cuda-11.7/lib64/stubs %post export DEBIAN_FRONTEND=noninteractive apt-get update @@ -122,11 +122,11 @@ From: ubuntu:18.04 wget https://developer.download.nvidia.com/compute/cuda/repos/ubuntu1804/x86_64/cuda-ubuntu1804.pin mv cuda-ubuntu1804.pin /etc/apt/preferences.d/cuda-repository-pin-600 - apt-key adv --fetch-keys https://developer.download.nvidia.com/compute/cuda/repos/ubuntu1804/x86_64/7fa2af80.pub + apt-key adv --fetch-keys https://developer.download.nvidia.com/compute/cuda/repos/ubuntu1804/x86_64/3bf863cc.pub add-apt-repository "deb http://developer.download.nvidia.com/compute/cuda/repos/ubuntu1804/x86_64/ /" apt-get update - export CUDA_PKG_VERSION=11.5 + export CUDA_PKG_VERSION=11.7 apt-get install -y --no-install-recommends \ cuda-libraries-${CUDA_PKG_VERSION} \ diff --git a/tools/singularity/ubuntu20.04_gpu.def b/tools/singularity/ubuntu20.04_gpu.def index 23bddeb14f..8c40f6c8d6 100644 --- a/tools/singularity/ubuntu20.04_gpu.def +++ b/tools/singularity/ubuntu20.04_gpu.def @@ -2,11 +2,11 @@ BootStrap: docker From: ubuntu:20.04 %environment - export PATH=/usr/lib/ccache:/usr/local/cuda-11.5/bin:${PATH}:/opt/rocm/bin:/opt/rocm/profiler/bin:/opt/rocm/opencl/bin/x86_64 - export CUDADIR=/usr/local/cuda-11.5 - export CUDA_PATH=/usr/local/cuda-11.5 - export LD_LIBRARY_PATH=$LD_LIBRARY_PATH:/usr/local/cuda-11.5/lib64:/opt/rocm/lib:/opt/rocm-4.5.0/llvm/lib - export LIBRARY_PATH=/usr/local/cuda-11.5/lib64/stubs + export PATH=/usr/lib/ccache:/usr/local/cuda-11.7/bin:${PATH}:/opt/rocm/bin:/opt/rocm/profiler/bin:/opt/rocm/opencl/bin/x86_64 + export CUDADIR=/usr/local/cuda-11.7 + export CUDA_PATH=/usr/local/cuda-11.7 + export LD_LIBRARY_PATH=$LD_LIBRARY_PATH:/usr/local/cuda-11.7/lib64:/opt/rocm/lib:/opt/rocm-4.5.0/llvm/lib + export LIBRARY_PATH=/usr/local/cuda-11.7/lib64/stubs %post export DEBIAN_FRONTEND=noninteractive apt-get update @@ -109,7 +109,7 @@ From: ubuntu:20.04 wget https://developer.download.nvidia.com/compute/cuda/repos/ubuntu2004/x86_64/cuda-ubuntu2004.pin mv cuda-ubuntu2004.pin /etc/apt/preferences.d/cuda-repository-pin-600 - apt-key adv --fetch-keys https://developer.download.nvidia.com/compute/cuda/repos/ubuntu2004/x86_64/7fa2af80.pub + apt-key adv --fetch-keys https://developer.download.nvidia.com/compute/cuda/repos/ubuntu2004/x86_64/3bf863cc.pub add-apt-repository "deb http://developer.download.nvidia.com/compute/cuda/repos/ubuntu2004/x86_64/ /" apt-get update From 7769a8e0de24c9d89191baf532fcc70bf3042495 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 8 Jun 2022 12:18:17 -0400 Subject: [PATCH 325/585] update ROCm to version 5.1.3 consistently --- tools/singularity/ubuntu18.04_amd_rocm.def | 8 ++++---- tools/singularity/ubuntu18.04_gpu.def | 6 +++--- tools/singularity/ubuntu20.04_amd_rocm.def | 8 ++++---- tools/singularity/ubuntu20.04_gpu.def | 8 ++++---- 4 files changed, 15 insertions(+), 15 deletions(-) diff --git a/tools/singularity/ubuntu18.04_amd_rocm.def b/tools/singularity/ubuntu18.04_amd_rocm.def index ceedfd8144..febdf1172e 100644 --- a/tools/singularity/ubuntu18.04_amd_rocm.def +++ b/tools/singularity/ubuntu18.04_amd_rocm.def @@ -3,7 +3,7 @@ From: ubuntu:18.04 %environment export PATH=/usr/lib/ccache:${PATH}:/opt/rocm/bin:/opt/rocm/profiler/bin:/opt/rocm/opencl/bin/x86_64 - export LD_LIBRARY_PATH=$LD_LIBRARY_PATH:/opt/rocm/lib:/opt/rocm-5.1.2/llvm/lib + export LD_LIBRARY_PATH=$LD_LIBRARY_PATH:/opt/rocm/lib:/opt/rocm-5.1.3/llvm/lib %post export DEBIAN_FRONTEND=noninteractive apt-get update @@ -22,10 +22,10 @@ From: ubuntu:18.04 apt install -y cmake ########################################################################### - # ROCm 5.1.2 + # ROCm 5.1.3 ########################################################################### - wget https://repo.radeon.com/amdgpu-install/22.10.2/ubuntu/bionic/amdgpu-install_22.10.2.50102-1_all.deb - apt-get install -y ./amdgpu-install_22.10.2.50102-1_all.deb + wget https://repo.radeon.com/amdgpu-install/22.10.3/ubuntu/bionic/amdgpu-install_22.10.3.50103-1_all.deb + apt-get install -y ./amdgpu-install_22.10.3.50103-1_all.deb apt-get update apt-get install --no-install-recommends -y \ diff --git a/tools/singularity/ubuntu18.04_gpu.def b/tools/singularity/ubuntu18.04_gpu.def index fac27dc7f3..7d639a1e1d 100644 --- a/tools/singularity/ubuntu18.04_gpu.def +++ b/tools/singularity/ubuntu18.04_gpu.def @@ -5,7 +5,7 @@ From: ubuntu:18.04 export PATH=/usr/lib/ccache:/usr/local/cuda-11.7/bin:${PATH}:/opt/rocm/bin:/opt/rocm/profiler/bin:/opt/rocm/opencl/bin/x86_64 export CUDADIR=/usr/local/cuda-11.7 export CUDA_PATH=/usr/local/cuda-11.7 - export LD_LIBRARY_PATH=$LD_LIBRARY_PATH:/usr/local/cuda-11.7/lib64:/opt/rocm/lib:/opt/rocm-4.5.0/llvm/lib + export LD_LIBRARY_PATH=$LD_LIBRARY_PATH:/usr/local/cuda-11.7/lib64:/opt/rocm/lib:/opt/rocm-5.1.3/llvm/lib export LIBRARY_PATH=/usr/local/cuda-11.7/lib64/stubs %post export DEBIAN_FRONTEND=noninteractive @@ -27,8 +27,8 @@ From: ubuntu:18.04 ########################################################################### # ROCm 4.5 ########################################################################### - wget https://repo.radeon.com/amdgpu-install/21.40/ubuntu/focal/amdgpu-install-21.40.40500-1_all.deb - apt-get install -y ./amdgpu-install-21.40.40500-1_all.deb + wget https://repo.radeon.com/amdgpu-install/22.10.3/ubuntu/focal/amdgpu-install-22.10.3.50103-1_all.deb + apt-get install -y ./amdgpu-install-22.10.3.50103-1_all.deb apt-get update apt-get install --no-install-recommends -y \ diff --git a/tools/singularity/ubuntu20.04_amd_rocm.def b/tools/singularity/ubuntu20.04_amd_rocm.def index 5e351e49a8..6034014370 100644 --- a/tools/singularity/ubuntu20.04_amd_rocm.def +++ b/tools/singularity/ubuntu20.04_amd_rocm.def @@ -3,7 +3,7 @@ From: ubuntu:20.04 %environment export PATH=/usr/lib/ccache:${PATH}:/opt/rocm/bin:/opt/rocm/profiler/bin:/opt/rocm/opencl/bin/x86_64 - export LD_LIBRARY_PATH=$LD_LIBRARY_PATH:/opt/rocm/lib:/opt/rocm-5.1.2/llvm/lib + export LD_LIBRARY_PATH=$LD_LIBRARY_PATH:/opt/rocm/lib:/opt/rocm-5.1.3/llvm/lib %post export DEBIAN_FRONTEND=noninteractive apt-get update @@ -13,10 +13,10 @@ From: ubuntu:20.04 apt-get install --no-install-recommends -y software-properties-common ########################################################################### - # ROCm 5.1.2 + # ROCm 5.1.3 ########################################################################### - wget https://repo.radeon.com/amdgpu-install/22.10.2/ubuntu/focal/amdgpu-install_22.10.2.50102-1_all.deb - apt-get install -y ./amdgpu-install_22.10.2.50102-1_all.deb + wget https://repo.radeon.com/amdgpu-install/22.10.3/ubuntu/focal/amdgpu-install_22.10.3.50103-1_all.deb + apt-get install -y ./amdgpu-install_22.10.3.50103-1_all.deb apt-get update apt-get install --no-install-recommends -y \ diff --git a/tools/singularity/ubuntu20.04_gpu.def b/tools/singularity/ubuntu20.04_gpu.def index 8c40f6c8d6..1e28ab95fa 100644 --- a/tools/singularity/ubuntu20.04_gpu.def +++ b/tools/singularity/ubuntu20.04_gpu.def @@ -5,7 +5,7 @@ From: ubuntu:20.04 export PATH=/usr/lib/ccache:/usr/local/cuda-11.7/bin:${PATH}:/opt/rocm/bin:/opt/rocm/profiler/bin:/opt/rocm/opencl/bin/x86_64 export CUDADIR=/usr/local/cuda-11.7 export CUDA_PATH=/usr/local/cuda-11.7 - export LD_LIBRARY_PATH=$LD_LIBRARY_PATH:/usr/local/cuda-11.7/lib64:/opt/rocm/lib:/opt/rocm-4.5.0/llvm/lib + export LD_LIBRARY_PATH=$LD_LIBRARY_PATH:/usr/local/cuda-11.7/lib64:/opt/rocm/lib:/opt/rocm-5.1.3/llvm/lib export LIBRARY_PATH=/usr/local/cuda-11.7/lib64/stubs %post export DEBIAN_FRONTEND=noninteractive @@ -15,10 +15,10 @@ From: ubuntu:20.04 apt-get install -y --no-install-recommends curl wget libnuma-dev gnupg ca-certificates ########################################################################### - # ROCm 4.5 + # ROCm 5.1.3 ########################################################################### - wget https://repo.radeon.com/amdgpu-install/21.40/ubuntu/focal/amdgpu-install-21.40.40500-1_all.deb - apt-get install -y ./amdgpu-install-21.40.40500-1_all.deb + wget https://repo.radeon.com/amdgpu-install/22.10.3/ubuntu/focal/amdgpu-install-22.10.3.50103-1_all.deb + apt-get install -y ./amdgpu-install-22.10.3.50103-1_all.deb apt-get update apt-get install --no-install-recommends -y \ From b6e0d7612303cde834fde55bd8a145a9fd983767 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 8 Jun 2022 12:47:30 -0400 Subject: [PATCH 326/585] fix some docs formatting issues --- doc/src/pair_e3b.rst | 91 +++++++++++++-------- doc/src/pair_sw_angle_table.rst | 4 +- doc/src/pair_threebody_table.rst | 6 +- doc/utils/sphinx-config/false_positives.txt | 1 + 4 files changed, 65 insertions(+), 37 deletions(-) diff --git a/doc/src/pair_e3b.rst b/doc/src/pair_e3b.rst index b75fb8450c..8ae6d10b82 100644 --- a/doc/src/pair_e3b.rst +++ b/doc/src/pair_e3b.rst @@ -50,6 +50,12 @@ Examples pair_style hybrid/overlay e3b 1 lj/cut/tip4p/long 1 2 1 1 0.15 8.5 pair_coeff * * e3b preset 2011 +Used in example input script: + +.. parsed-literal:: + + examples/PACKAGES/e3b/in.e3b-tip4p2005 + Description """"""""""" @@ -68,21 +74,27 @@ The *e3b* style computes an \"explicit three-body\" (E3B) potential for water :r 0 & r>R_f\\ \end{cases} -This potential was developed as a water model that includes the three-body cooperativity of hydrogen bonding explicitly. -To use it in this way, it must be applied in conjunction with a conventional two-body water model, through *pair_style hybrid/overlay*. -The three body interactions are split into three types: A, B, and C. -Type A corresponds to anti-cooperative double hydrogen bond donor interactions. -Type B corresponds to the cooperative interaction of molecules that both donate and accept a hydrogen bond. -Type C corresponds to anti-cooperative double hydrogen bond acceptor interactions. -The three-body interactions are smoothly cutoff by the switching function s(r) between Rs and Rc3. -The two-body interactions are designed to correct for the effective many-body interactions implicitly included in the conventional two-body potential. -The two-body interactions are cut off sharply at Rc2, because K3 is typically significantly smaller than K2. -See :ref:`(Kumar 2008) ` for more details. +This potential was developed as a water model that includes the +three-body cooperativity of hydrogen bonding explicitly. To use it in +this way, it must be applied in conjunction with a conventional two-body +water model, through pair style :doc:`hybrid/overlay `. The +three body interactions are split into three types: A, B, and C. Type A +corresponds to anti-cooperative double hydrogen bond donor interactions. +Type B corresponds to the cooperative interaction of molecules that both +donate and accept a hydrogen bond. Type C corresponds to +anti-cooperative double hydrogen bond acceptor interactions. The +three-body interactions are smoothly cutoff by the switching function +s(r) between Rs and Rc3. The two-body interactions are designed to +correct for the effective many-body interactions implicitly included in +the conventional two-body potential. The two-body interactions are cut +off sharply at Rc2, because K3 is typically significantly smaller than +K2. See :ref:`(Kumar 2008) ` for more details. -Only a single *pair_coeff* command is used with the *e3b* style. -The first two arguments must be \* \*. -The oxygen atom type for the pair style is passed as the only argument to the *pair_style* command, not in the *pair_coeff* command. -The hydrogen atom type is inferred by the ordering of the atoms. +Only a single :doc:`pair_coeff ` command is used with the +*e3b* style and the first two arguments must be \* \*. The oxygen atom +type for the pair style is passed as the only argument to the +*pair_style* command, not in the *pair_coeff* command. The hydrogen +atom type is inferred from the ordering of the atoms. .. note:: @@ -90,26 +102,41 @@ The hydrogen atom type is inferred by the ordering of the atoms. Each water molecule must have consecutive IDs with the oxygen first. This pair style does not test that this criteria is met. -The *pair_coeff* command must have at least one keyword/value pair, as described above. -The *preset* keyword sets the potential parameters to the values used in :ref:`(Tainter 2011) ` or :ref:`(Tainter 2015) `. -To use the water models defined in those references, the *e3b* style should always be used in conjunction with an *lj/cut/tip4p/long* style through *pair_style hybrid/overlay*, as demonstrated in the second example above. -The *preset 2011* option should be used with the :doc:`TIP4P water model `. -The *preset 2015* option should be used with the :doc:`TIP4P/2005 water model `. -If the *preset* keyword is used, no other keyword is needed. -Changes to the preset parameters can be made by specifying the *preset* keyword followed by the specific parameter to change, like *Ea*\ . -Note that the other keywords must come after *preset* in the pair_style command. -The *e3b* style can also be used to implement any three-body potential of the same form by specifying all the keywords except *neigh*\ : *Ea*, *Eb*, *Ec*, *E2*, *K3*, *K2*, *Rc3*, *Rc2*, *Rs*, and *bondL*\ . -The keyword *bondL* specifies the intramolecular OH bond length of the water model being used. -This is needed to include H atoms that are within the cutoff even when the attached oxygen atom is not. +The *pair_coeff* command must have at least one keyword/value pair, as +described above. The *preset* keyword sets the potential parameters to +the values used in :ref:`(Tainter 2011) ` or +:ref:`(Tainter 2015) `. To use the water models defined in +those references, the *e3b* style should always be used in conjunction +with an *lj/cut/tip4p/long* style through *pair_style hybrid/overlay*, +as demonstrated in the second example above. The *preset 2011* option +should be used with the :doc:`TIP4P water model `. The +*preset 2015* option should be used with the :doc:`TIP4P/2005 water +model `. If the *preset* keyword is used, no other keyword +is needed. Changes to the preset parameters can be made by specifying +the *preset* keyword followed by the specific parameter to change, like +*Ea*\ . Note that the other keywords must come after *preset* in the +pair_style command. The *e3b* style can also be used to implement any +three-body potential of the same form by specifying all the keywords +except *neigh*\ : *Ea*, *Eb*, *Ec*, *E2*, *K3*, *K2*, *Rc3*, *Rc2*, +*Rs*, and *bondL*\ . The keyword *bondL* specifies the intramolecular +OH bond length of the water model being used. This is needed to include +H atoms that are within the cutoff even when the attached oxygen atom is +not. -This pair style allocates arrays sized according to the number of pairwise interactions within Rc3. -To do this it needs an estimate for the number of water molecules within Rc3 of an oxygen atom. -This estimate defaults to 10 and can be changed using the *neigh* keyword, which takes an integer as an argument. -If the neigh setting is too small, the simulation will fail with the error "neigh is too small". -If the neigh setting is too large, the pair style will use more memory than necessary. +This pair style allocates arrays sized according to the number of +pairwise interactions within Rc3. To do this it needs an estimate for +the number of water molecules within Rc3 of an oxygen atom. This +estimate defaults to 10 and can be changed using the *neigh* keyword, +which takes an integer as an argument. If the neigh setting is too +small, the simulation will fail with the error "neigh is too small". If +the neigh setting is too large, the pair style will use more memory than +necessary. -This pair style tallies a breakdown of the total E3B potential energy into sub-categories, which can be accessed via the :doc:`compute pair ` command as a vector of values of length 4. -The 4 values correspond to the terms in the first equation above: the E2 term, the Ea term, the Eb term, and the Ec term. +This pair style tallies a breakdown of the total E3B potential energy +into sub-categories, which can be accessed via the :doc:`compute pair +` command as a vector of values of length 4. The 4 values +correspond to the terms in the first equation above: the E2 term, the Ea +term, the Eb term, and the Ec term. See the examples/PACKAGES/e3b directory for a complete example script. diff --git a/doc/src/pair_sw_angle_table.rst b/doc/src/pair_sw_angle_table.rst index 6431917d67..ff88711d7a 100644 --- a/doc/src/pair_sw_angle_table.rst +++ b/doc/src/pair_sw_angle_table.rst @@ -23,9 +23,9 @@ Examples Used in example input script: - .. parsed-literal:: +.. parsed-literal:: - examples/PACKAGES/manybody_table/in.spce_sw + examples/PACKAGES/manybody_table/in.spce_sw Description diff --git a/doc/src/pair_threebody_table.rst b/doc/src/pair_threebody_table.rst index 68661270c9..19c90feccd 100644 --- a/doc/src/pair_threebody_table.rst +++ b/doc/src/pair_threebody_table.rst @@ -27,10 +27,10 @@ Examples Used in example input scripts: - .. parsed-literal:: +.. parsed-literal:: - examples/PACKAGES/manybody_table/in.spce - examples/PACKAGES/manybody_table/in.spce2 + examples/PACKAGES/manybody_table/in.spce + examples/PACKAGES/manybody_table/in.spce2 Description """"""""""" diff --git a/doc/utils/sphinx-config/false_positives.txt b/doc/utils/sphinx-config/false_positives.txt index 0912a63352..b42cff262a 100644 --- a/doc/utils/sphinx-config/false_positives.txt +++ b/doc/utils/sphinx-config/false_positives.txt @@ -120,6 +120,7 @@ Antonelli api Apoorva Appl +apptainer Apu arallel arccos From 5fca9f4d1fb0bbfb44c8d72af43b247fed980f73 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 8 Jun 2022 17:04:26 -0400 Subject: [PATCH 327/585] update mathjax version with bugfix release --- doc/Makefile | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/doc/Makefile b/doc/Makefile index 07b201b07e..8841ae4825 100644 --- a/doc/Makefile +++ b/doc/Makefile @@ -13,7 +13,7 @@ VENV = $(BUILDDIR)/docenv ANCHORCHECK = $(VENV)/bin/rst_anchor_check SPHINXCONFIG = $(BUILDDIR)/utils/sphinx-config MATHJAX = $(SPHINXCONFIG)/_static/mathjax -MATHJAXTAG = 3.2.1 +MATHJAXTAG = 3.2.2 PYTHON = $(word 3,$(shell type python3)) DOXYGEN = $(word 3,$(shell type doxygen)) From 68a9db0950cb5d03219b0cf9e2605210d325d2de Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 8 Jun 2022 17:07:08 -0400 Subject: [PATCH 328/585] fix typos --- tools/singularity/ubuntu18.04_gpu.def | 4 ++-- tools/singularity/ubuntu20.04_gpu.def | 4 ++-- 2 files changed, 4 insertions(+), 4 deletions(-) diff --git a/tools/singularity/ubuntu18.04_gpu.def b/tools/singularity/ubuntu18.04_gpu.def index 7d639a1e1d..90034285ff 100644 --- a/tools/singularity/ubuntu18.04_gpu.def +++ b/tools/singularity/ubuntu18.04_gpu.def @@ -27,8 +27,8 @@ From: ubuntu:18.04 ########################################################################### # ROCm 4.5 ########################################################################### - wget https://repo.radeon.com/amdgpu-install/22.10.3/ubuntu/focal/amdgpu-install-22.10.3.50103-1_all.deb - apt-get install -y ./amdgpu-install-22.10.3.50103-1_all.deb + wget https://repo.radeon.com/amdgpu-install/22.10.3/ubuntu/focal/amdgpu-install_22.10.3.50103-1_all.deb + apt-get install -y ./amdgpu-install_22.10.3.50103-1_all.deb apt-get update apt-get install --no-install-recommends -y \ diff --git a/tools/singularity/ubuntu20.04_gpu.def b/tools/singularity/ubuntu20.04_gpu.def index 1e28ab95fa..f7bab1ee9d 100644 --- a/tools/singularity/ubuntu20.04_gpu.def +++ b/tools/singularity/ubuntu20.04_gpu.def @@ -17,8 +17,8 @@ From: ubuntu:20.04 ########################################################################### # ROCm 5.1.3 ########################################################################### - wget https://repo.radeon.com/amdgpu-install/22.10.3/ubuntu/focal/amdgpu-install-22.10.3.50103-1_all.deb - apt-get install -y ./amdgpu-install-22.10.3.50103-1_all.deb + wget https://repo.radeon.com/amdgpu-install/22.10.3/ubuntu/focal/amdgpu-install_22.10.3.50103-1_all.deb + apt-get install -y ./amdgpu-install_22.10.3.50103-1_all.deb apt-get update apt-get install --no-install-recommends -y \ From 302287e4d0b92dc91aa944f7439253505015c498 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Thu, 9 Jun 2022 14:19:53 -0600 Subject: [PATCH 329/585] debug comment for extending preconditioner neigh list --- src/AMOEBA/pair_amoeba.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/AMOEBA/pair_amoeba.cpp b/src/AMOEBA/pair_amoeba.cpp index 5c12dc419c..1c17e3b2ae 100644 --- a/src/AMOEBA/pair_amoeba.cpp +++ b/src/AMOEBA/pair_amoeba.cpp @@ -1751,7 +1751,7 @@ void PairAmoeba::precond_neigh() int *neighptr; // set cutoffs and taper coeffs - // add skin to cutoff, same as for main neighbor list + // NOTE: add skin to cutoff, same as for main neighbor list ?? choose(USOLV); From 7f1e76b7a5b860aac4c20887f4ef5c7adbc01662 Mon Sep 17 00:00:00 2001 From: Stan Gerald Moore Date: Thu, 9 Jun 2022 14:53:44 -0600 Subject: [PATCH 330/585] Don't compute count twice --- src/EXTRA-COMPUTE/compute_ave_sphere_atom.cpp | 2 -- src/KOKKOS/compute_ave_sphere_atom_kokkos.cpp | 2 -- 2 files changed, 4 deletions(-) diff --git a/src/EXTRA-COMPUTE/compute_ave_sphere_atom.cpp b/src/EXTRA-COMPUTE/compute_ave_sphere_atom.cpp index 45cab08329..8181172d30 100644 --- a/src/EXTRA-COMPUTE/compute_ave_sphere_atom.cpp +++ b/src/EXTRA-COMPUTE/compute_ave_sphere_atom.cpp @@ -215,7 +215,6 @@ void ComputeAveSphereAtom::compute_peratom() // i atom contribution - count = 1; totalmass = massone_i; vnet[0] = v[i][0] - vavg[0]; vnet[1] = v[i][1] - vavg[1]; @@ -231,7 +230,6 @@ void ComputeAveSphereAtom::compute_peratom() delz = ztmp - x[j][2]; rsq = delx * delx + dely * dely + delz * delz; if (rsq < cutsq) { - count++; totalmass += massone_j; vnet[0] = v[j][0] - vavg[0]; vnet[1] = v[j][1] - vavg[1]; diff --git a/src/KOKKOS/compute_ave_sphere_atom_kokkos.cpp b/src/KOKKOS/compute_ave_sphere_atom_kokkos.cpp index ed54a92f63..df3998e35a 100644 --- a/src/KOKKOS/compute_ave_sphere_atom_kokkos.cpp +++ b/src/KOKKOS/compute_ave_sphere_atom_kokkos.cpp @@ -177,7 +177,6 @@ void ComputeAveSphereAtomKokkos::operator()(TagComputeAveSphereAtom, // i atom contribution - count = 1; totalmass = massone_i; double vnet[3]; vnet[0] = v(i,0) - vavg[0]; @@ -196,7 +195,6 @@ void ComputeAveSphereAtomKokkos::operator()(TagComputeAveSphereAtom, const F_FLOAT delz = x(j,2) - ztmp; const F_FLOAT rsq = delx*delx + dely*dely + delz*delz; if (rsq < cutsq) { - count++; totalmass += massone_j; vnet[0] = v(j,0) - vavg[0]; vnet[1] = v(j,1) - vavg[1]; From 9be6e2a064237ac92769783c44a4985fd901bc26 Mon Sep 17 00:00:00 2001 From: Stan Gerald Moore Date: Thu, 9 Jun 2022 15:29:40 -0600 Subject: [PATCH 331/585] Use COM velocity --- src/EXTRA-COMPUTE/compute_ave_sphere_atom.cpp | 36 +++++++++--------- src/KOKKOS/compute_ave_sphere_atom_kokkos.cpp | 37 ++++++++++--------- 2 files changed, 37 insertions(+), 36 deletions(-) diff --git a/src/EXTRA-COMPUTE/compute_ave_sphere_atom.cpp b/src/EXTRA-COMPUTE/compute_ave_sphere_atom.cpp index 8181172d30..8638ba1fc0 100644 --- a/src/EXTRA-COMPUTE/compute_ave_sphere_atom.cpp +++ b/src/EXTRA-COMPUTE/compute_ave_sphere_atom.cpp @@ -125,7 +125,7 @@ void ComputeAveSphereAtom::compute_peratom() double xtmp, ytmp, ztmp, delx, dely, delz, rsq; int *ilist, *jlist, *numneigh, **firstneigh; int count; - double vsum[3], vavg[3], vnet[3]; + double p[3], vcom[3], vnet[3]; invoked_peratom = update->ntimestep; @@ -185,9 +185,10 @@ void ComputeAveSphereAtom::compute_peratom() // i atom contribution count = 1; - vsum[0] = v[i][0]; - vsum[1] = v[i][1]; - vsum[2] = v[i][2]; + totalmass = massone_i; + p[0] = v[i][0] * massone_i; + p[1] = v[i][1] * massone_i; + p[2] = v[i][2] * massone_i; for (jj = 0; jj < jnum; jj++) { j = jlist[jj]; @@ -203,22 +204,22 @@ void ComputeAveSphereAtom::compute_peratom() rsq = delx * delx + dely * dely + delz * delz; if (rsq < cutsq) { count++; - vsum[0] += v[j][0]; - vsum[1] += v[j][1]; - vsum[2] += v[j][2]; + totalmass += massone_j; + p[0] += v[j][0] * massone_j; + p[1] += v[j][1] * massone_j; + p[2] += v[j][2] * massone_j; } } - vavg[0] = vsum[0] / count; - vavg[1] = vsum[1] / count; - vavg[2] = vsum[2] / count; + vcom[0] = p[0] / totalmass; + vcom[1] = p[1] / totalmass; + vcom[2] = p[2] / totalmass; // i atom contribution - totalmass = massone_i; - vnet[0] = v[i][0] - vavg[0]; - vnet[1] = v[i][1] - vavg[1]; - vnet[2] = v[i][2] - vavg[2]; + vnet[0] = v[i][0] - vcom[0]; + vnet[1] = v[i][1] - vcom[1]; + vnet[2] = v[i][2] - vcom[2]; double ke_sum = massone_i * (vnet[0] * vnet[0] + vnet[1] * vnet[1] + vnet[2] * vnet[2]); for (jj = 0; jj < jnum; jj++) { @@ -230,10 +231,9 @@ void ComputeAveSphereAtom::compute_peratom() delz = ztmp - x[j][2]; rsq = delx * delx + dely * dely + delz * delz; if (rsq < cutsq) { - totalmass += massone_j; - vnet[0] = v[j][0] - vavg[0]; - vnet[1] = v[j][1] - vavg[1]; - vnet[2] = v[j][2] - vavg[2]; + vnet[0] = v[j][0] - vcom[0]; + vnet[1] = v[j][1] - vcom[1]; + vnet[2] = v[j][2] - vcom[2]; ke_sum += massone_j * (vnet[0] * vnet[0] + vnet[1] * vnet[1] + vnet[2] * vnet[2]); } } diff --git a/src/KOKKOS/compute_ave_sphere_atom_kokkos.cpp b/src/KOKKOS/compute_ave_sphere_atom_kokkos.cpp index df3998e35a..6e7abdcf23 100644 --- a/src/KOKKOS/compute_ave_sphere_atom_kokkos.cpp +++ b/src/KOKKOS/compute_ave_sphere_atom_kokkos.cpp @@ -149,10 +149,11 @@ void ComputeAveSphereAtomKokkos::operator()(TagComputeAveSphereAtom, // i atom contribution int count = 1; - double vsum[3]; - vsum[0] = v(i,0); - vsum[1] = v(i,1); - vsum[2] = v(i,2); + double totalmass = massone_i; + double p[3]; + p[0] = v(i,0)*massone_i; + p[1] = v(i,1)*massone_i; + p[2] = v(i,2)*massone_i; for (int jj = 0; jj < jnum; jj++) { int j = d_neighbors(i,jj); @@ -164,24 +165,25 @@ void ComputeAveSphereAtomKokkos::operator()(TagComputeAveSphereAtom, const F_FLOAT rsq = delx*delx + dely*dely + delz*delz; if (rsq < cutsq) { count++; - vsum[0] += v(j,0); - vsum[1] += v(j,1); - vsum[2] += v(j,2); + totalmass += massone_j; + p[0] += v(j,0)*massone_j; + p[1] += v(j,1)*massone_j; + p[2] += v(j,2)*massone_j; } } - double vavg[3]; - vavg[0] = vsum[0]/count; - vavg[1] = vsum[1]/count; - vavg[2] = vsum[2]/count; + double vcom[3]; + vcom[0] = p[0]/totalmass; + vcom[1] = p[1]/totalmass; + vcom[2] = p[2]/totalmass; // i atom contribution totalmass = massone_i; double vnet[3]; - vnet[0] = v(i,0) - vavg[0]; - vnet[1] = v(i,1) - vavg[1]; - vnet[2] = v(i,2) - vavg[2]; + vnet[0] = v(i,0) - vcom[0]; + vnet[1] = v(i,1) - vcom[1]; + vnet[2] = v(i,2) - vcom[2]; double ke_sum = massone_i * (vnet[0]*vnet[0] + vnet[1]*vnet[1] + vnet[2]*vnet[2]); for (int jj = 0; jj < jnum; jj++) { @@ -195,10 +197,9 @@ void ComputeAveSphereAtomKokkos::operator()(TagComputeAveSphereAtom, const F_FLOAT delz = x(j,2) - ztmp; const F_FLOAT rsq = delx*delx + dely*dely + delz*delz; if (rsq < cutsq) { - totalmass += massone_j; - vnet[0] = v(j,0) - vavg[0]; - vnet[1] = v(j,1) - vavg[1]; - vnet[2] = v(j,2) - vavg[2]; + vnet[0] = v(j,0) - vcom[0]; + vnet[1] = v(j,1) - vcom[1]; + vnet[2] = v(j,2) - vcom[2]; ke_sum += massone_j * (vnet[0]*vnet[0] + vnet[1]*vnet[1] + vnet[2]*vnet[2]); } } From 80727e47f44e93fa3f32c39fd13ead8c066013ff Mon Sep 17 00:00:00 2001 From: Stan Gerald Moore Date: Thu, 9 Jun 2022 15:31:48 -0600 Subject: [PATCH 332/585] Add attribution --- src/EXTRA-COMPUTE/compute_ave_sphere_atom.cpp | 4 ++++ src/KOKKOS/compute_ave_sphere_atom_kokkos.cpp | 4 ++++ 2 files changed, 8 insertions(+) diff --git a/src/EXTRA-COMPUTE/compute_ave_sphere_atom.cpp b/src/EXTRA-COMPUTE/compute_ave_sphere_atom.cpp index 8638ba1fc0..a477da0511 100644 --- a/src/EXTRA-COMPUTE/compute_ave_sphere_atom.cpp +++ b/src/EXTRA-COMPUTE/compute_ave_sphere_atom.cpp @@ -11,6 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +/* ---------------------------------------------------------------------- + Contributing author: Stan Moore (SNL) +------------------------------------------------------------------------- */ + #include "compute_ave_sphere_atom.h" #include "atom.h" diff --git a/src/KOKKOS/compute_ave_sphere_atom_kokkos.cpp b/src/KOKKOS/compute_ave_sphere_atom_kokkos.cpp index 6e7abdcf23..e79259e99d 100644 --- a/src/KOKKOS/compute_ave_sphere_atom_kokkos.cpp +++ b/src/KOKKOS/compute_ave_sphere_atom_kokkos.cpp @@ -11,6 +11,10 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +/* ---------------------------------------------------------------------- + Contributing author: Stan Moore (SNL) +------------------------------------------------------------------------- */ + #include "compute_ave_sphere_atom_kokkos.h" #include "atom_kokkos.h" From 5d7b1f3ebb3baf0cae21a7ec6d87027d5f6afdec Mon Sep 17 00:00:00 2001 From: Stan Gerald Moore Date: Thu, 9 Jun 2022 15:36:17 -0600 Subject: [PATCH 333/585] fix small issues --- src/KOKKOS/compute_ave_sphere_atom_kokkos.cpp | 3 +-- 1 file changed, 1 insertion(+), 2 deletions(-) diff --git a/src/KOKKOS/compute_ave_sphere_atom_kokkos.cpp b/src/KOKKOS/compute_ave_sphere_atom_kokkos.cpp index e79259e99d..32d3078aa8 100644 --- a/src/KOKKOS/compute_ave_sphere_atom_kokkos.cpp +++ b/src/KOKKOS/compute_ave_sphere_atom_kokkos.cpp @@ -138,7 +138,7 @@ template KOKKOS_INLINE_FUNCTION void ComputeAveSphereAtomKokkos::operator()(TagComputeAveSphereAtom, const int &ii) const { - double massone_i,massone_j,totalmass; + double massone_i,massone_j; const int i = d_ilist[ii]; if (mask[i] & groupbit) { @@ -183,7 +183,6 @@ void ComputeAveSphereAtomKokkos::operator()(TagComputeAveSphereAtom, // i atom contribution - totalmass = massone_i; double vnet[3]; vnet[0] = v(i,0) - vcom[0]; vnet[1] = v(i,1) - vcom[1]; From 495418158a3da1488966408648921417e7584a56 Mon Sep 17 00:00:00 2001 From: Stan Gerald Moore Date: Thu, 9 Jun 2022 15:51:31 -0600 Subject: [PATCH 334/585] Clarify doc page --- doc/src/compute_ave_sphere_atom.rst | 7 +++++-- src/EXTRA-COMPUTE/compute_ave_sphere_atom.cpp | 4 ++++ src/KOKKOS/compute_ave_sphere_atom_kokkos.cpp | 2 ++ 3 files changed, 11 insertions(+), 2 deletions(-) diff --git a/doc/src/compute_ave_sphere_atom.rst b/doc/src/compute_ave_sphere_atom.rst index 0cf631a941..a6607356c9 100644 --- a/doc/src/compute_ave_sphere_atom.rst +++ b/doc/src/compute_ave_sphere_atom.rst @@ -36,7 +36,9 @@ Description """"""""""" Define a computation that calculates the local mass density and temperature -for each atom and neighbors inside a spherical cutoff. +for each atom and neighbors inside a spherical cutoff. The center-of-mass +velocity of the atoms in the sphere is subtracted out before computing the +temperature, which leaves only the thermal velocity, similar to :doc:`compute temp/com `. The optional keyword *cutoff* defines the distance cutoff used when searching for neighbors. The default value is the cutoff @@ -77,7 +79,8 @@ too frequently. Output info """"""""""" -This compute calculates a per-atom array with two columns: mass density and temperature. +This compute calculates a per-atom array with two columns: mass density in density +:doc:`units ` and temperature in temperature :doc:`units `. These values can be accessed by any command that uses per-atom values from a compute as input. See the :doc:`Howto output ` doc diff --git a/src/EXTRA-COMPUTE/compute_ave_sphere_atom.cpp b/src/EXTRA-COMPUTE/compute_ave_sphere_atom.cpp index a477da0511..010051029a 100644 --- a/src/EXTRA-COMPUTE/compute_ave_sphere_atom.cpp +++ b/src/EXTRA-COMPUTE/compute_ave_sphere_atom.cpp @@ -229,6 +229,10 @@ void ComputeAveSphereAtom::compute_peratom() for (jj = 0; jj < jnum; jj++) { j = jlist[jj]; j &= NEIGHMASK; + if (rmass) + massone_j = rmass[j]; + else + massone_j = mass[type[j]]; delx = xtmp - x[j][0]; dely = ytmp - x[j][1]; diff --git a/src/KOKKOS/compute_ave_sphere_atom_kokkos.cpp b/src/KOKKOS/compute_ave_sphere_atom_kokkos.cpp index 32d3078aa8..7873bd0d92 100644 --- a/src/KOKKOS/compute_ave_sphere_atom_kokkos.cpp +++ b/src/KOKKOS/compute_ave_sphere_atom_kokkos.cpp @@ -162,6 +162,8 @@ void ComputeAveSphereAtomKokkos::operator()(TagComputeAveSphereAtom, for (int jj = 0; jj < jnum; jj++) { int j = d_neighbors(i,jj); j &= NEIGHMASK; + if (rmass.data()) massone_j = rmass[j]; + else massone_j = mass[type[j]]; const F_FLOAT delx = x(j,0) - xtmp; const F_FLOAT dely = x(j,1) - ytmp; From 41a34a498812e1c10b090f9e6102442903eca122 Mon Sep 17 00:00:00 2001 From: Jacob Gissinger Date: Thu, 9 Jun 2022 23:22:16 -0400 Subject: [PATCH 335/585] reaxff/species delete keyword --- src/REAXFF/fix_reaxff_species.cpp | 225 +++++++++++++++++++++++++++++- src/REAXFF/fix_reaxff_species.h | 16 ++- 2 files changed, 232 insertions(+), 9 deletions(-) diff --git a/src/REAXFF/fix_reaxff_species.cpp b/src/REAXFF/fix_reaxff_species.cpp index a89cd6f0dc..9f39afd793 100644 --- a/src/REAXFF/fix_reaxff_species.cpp +++ b/src/REAXFF/fix_reaxff_species.cpp @@ -19,6 +19,7 @@ #include "fix_reaxff_species.h" #include "atom.h" +#include "atom_vec.h" #include "comm.h" #include "domain.h" #include "error.h" @@ -45,7 +46,8 @@ FixReaxFFSpecies::FixReaxFFSpecies(LAMMPS *lmp, int narg, char **arg) : Fix(lmp, { if (narg < 7) error->all(FLERR, "Illegal fix reaxff/species command"); - force_reneighbor = 0; + force_reneighbor = 1; + next_reneighbor = -1; vector_flag = 1; size_vector = 2; @@ -125,8 +127,10 @@ FixReaxFFSpecies::FixReaxFFSpecies(LAMMPS *lmp, int narg, char **arg) : Fix(lmp, MolName = nullptr; MolType = nullptr; NMol = nullptr; + Mol2Spec = nullptr; nd = nullptr; molmap = nullptr; + mark = nullptr; nmax = 0; setupflag = 0; @@ -142,10 +146,11 @@ FixReaxFFSpecies::FixReaxFFSpecies(LAMMPS *lmp, int narg, char **arg) : Fix(lmp, // optional args eletype = nullptr; - ele = filepos = nullptr; + ele = filepos = filedel = nullptr; eleflag = posflag = padflag = 0; + delflag = masslimitflag = 0; - singlepos_opened = multipos_opened = 0; + singlepos_opened = multipos_opened = del_opened = 0; multipos = 0; posfreq = 0; @@ -180,6 +185,43 @@ FixReaxFFSpecies::FixReaxFFSpecies(LAMMPS *lmp, int narg, char **arg) : Fix(lmp, eleflag = 1; iarg += ntypes + 1; + // delete species + } else if (strcmp(arg[iarg],"delete") == 0) { + delflag = 1; + + filedel = new char[255]; + strcpy(filedel,arg[iarg+1]); + if (me == 0) { + fdel = fopen(filedel, "w"); + if (fdel == nullptr) error->one(FLERR,"Cannot open fix reaxff/species delete file"); + } + + del_opened = 1; + + if (strcmp(arg[iarg+2],"masslimit") == 0) { + masslimitflag = 1; + massmin = atof(arg[iarg+3]); + massmax = atof(arg[iarg+4]); + iarg += 5; + } else { + ndelspec = atoi(arg[iarg+2]); + if (iarg+ndelspec+3 > narg) error->all(FLERR,"Illegal fix reaxff/species command"); + + del_species.resize(ndelspec); + for (int i = 0; i < ndelspec; i ++) + del_species[i] = arg[iarg+3+i]; + + if (me == 0) { + fprintf(fdel,"Timestep"); + for (i = 0; i < ndelspec; i++) + fprintf(fdel,"\t%s",del_species[i].c_str()); + fprintf(fdel,"\n"); + fflush(fdel); + } + + iarg += ndelspec + 3; + } + // position of molecules } else if (strcmp(arg[iarg], "position") == 0) { if (iarg + 3 > narg) error->all(FLERR, "Illegal fix reaxff/species command"); @@ -229,6 +271,7 @@ FixReaxFFSpecies::~FixReaxFFSpecies() memory->destroy(nd); memory->destroy(Name); memory->destroy(NMol); + memory->destroy(Mol2Spec); memory->destroy(MolType); memory->destroy(MolName); @@ -358,6 +401,8 @@ void FixReaxFFSpecies::Output_ReaxFF_Bonds(bigint ntimestep, FILE * /*fp*/) if (me == 0) fflush(pos); } + if (delflag) DeleteSpecies(Nmole, Nspec); + nvalid += nfreq; } @@ -540,6 +585,11 @@ void FixReaxFFSpecies::FindSpecies(int Nmole, int &Nspec) memory->create(Nameall, ntypes, "reaxff/species:Nameall"); memory->create(NMolall, Nmole, "reaxff/species:NMolall"); + memory->destroy(Mol2Spec); + Mol2Spec = nullptr; + memory->create(Mol2Spec, Nmole, "reaxff/species:Mol2Spec"); + for (m = 0; m < Nmole; m++) Mol2Spec[m] = -1; + for (m = 1, Nspec = 0; m <= Nmole; m++) { for (n = 0; n < ntypes; n++) Name[n] = 0; for (n = 0, flag_mol = 0; n < nlocal; n++) { @@ -563,11 +613,15 @@ void FixReaxFFSpecies::FindSpecies(int Nmole, int &Nspec) flag_spec = 0; for (l = 0; l < ntypes; l++) if (MolName[ntypes * k + l] != Name[l]) flag_spec = 1; - if (flag_spec == 0) NMol[k]++; + if (flag_spec == 0) { + NMol[k]++; + Mol2Spec[m-1] = k; + } flag_identity *= flag_spec; } if (Nspec == 0 || flag_identity == 1) { for (l = 0; l < ntypes; l++) MolName[ntypes * Nspec + l] = Name[l]; + Mol2Spec[m-1] = Nspec; Nspec++; } } @@ -758,6 +812,169 @@ void FixReaxFFSpecies::WritePos(int Nmole, int Nspec) /* ---------------------------------------------------------------------- */ +void FixReaxFFSpecies::DeleteSpecies(int Nmole, int Nspec) +{ + int i, j, m, n, k, itype, cid; + int ndel, ndelone, count, count_tmp; + int *Nameall; + int *mask = atom->mask; + double localmass, totalmass; + double **spec_atom = f_SPECBOND->array_atom; + std::string species_str; + + AtomVec *avec = atom->avec; + + mark = nullptr; + memory->create(mark, nlocal, "reaxff/species:mark"); + for (i = 0; i < nlocal; i++) mark[i] = 0; + + Nameall = nullptr; + memory->create(Nameall, ntypes, "reaxff/species:Nameall"); + + int ndelcomm; + if (masslimitflag) ndelcomm = Nspec; + else ndelcomm = ndelspec; + + double *deletecount; + memory->create(deletecount, ndelcomm, "reaxff/species:deletecount"); + for (i = 0; i < ndelcomm; i++) deletecount[i] = 0; + + int nmarklist; + int *marklist; + memory->create(marklist, nlocal, "reaxff/species:marklist"); + + for (m = 1; m <= Nmole; m++) { + localmass = totalmass = count = nmarklist = 0; + for (n = 0; n < ntypes; n++) Name[n] = 0; + + for (i = 0; i < nlocal; i++) { + if (!(mask[i] & groupbit)) continue; + cid = nint(clusterID[i]); + if (cid == m) { + itype = atom->type[i]-1; + Name[itype]++; + count++; + marklist[nmarklist++] = i; + localmass += atom->mass[atom->type[i]]; + } + } + + MPI_Allreduce(&count, &count_tmp, 1, MPI_INT, MPI_SUM, world); + count = count_tmp; + + MPI_Allreduce(Name, Nameall, ntypes, MPI_INT, MPI_SUM, world); + for (n = 0; n < ntypes; n++) Name[n] = Nameall[n]; + + MPI_Allreduce(&localmass, &totalmass, 1 , MPI_DOUBLE, MPI_SUM, world); + + species_str = ""; + for (j = 0; j < ntypes; j++) { + if (Name[j] != 0) { + if (eletype) species_str += eletype[j]; + else species_str += ele[j]; + if (Name[j] != 1) species_str += fmt::format("{}",Name[j]); + } + } + + if (masslimitflag) { + + // find corresponding moltype + + if (totalmass > massmin && totalmass < massmax) { + for (j = 0; j < nmarklist; j++) { + mark[marklist[j]] = 1; + deletecount[Mol2Spec[m-1]] += 1.0 / (double) count; + } + } + } else { + if (count > 0) { + for (i = 0; i < ndelspec; i++) { + if (del_species[i] == species_str) { + for (j = 0; j < nmarklist; j++) { + mark[marklist[j]] = 1; + deletecount[i] += 1.0 / (double) count; + } + break; + } + } + } + } + } + + // delete atoms. loop in reverse order to avoid copying marked atoms + + ndel = ndelone = 0; + for (i = atom->nlocal-1; i >= 0; i--) { + if (mark[i] == 1) { + avec->copy(atom->nlocal-1,i,1); + atom->nlocal--; + ndelone++; + } + } + + MPI_Allreduce(&ndelone, &ndel, 1, MPI_INT, MPI_SUM, world); + + atom->natoms -= ndel; + + if (me == 0) MPI_Reduce(MPI_IN_PLACE, deletecount, ndelcomm, MPI_DOUBLE, MPI_SUM, 0, world); + else MPI_Reduce(deletecount, deletecount, ndelcomm, MPI_DOUBLE, MPI_SUM, 0, world); + + if (me == 0) { + if (masslimitflag) { + int printflag = 0; + for (int m = 0; m < Nspec; m++) { + if (deletecount[m] > 0) { + if (printflag == 0) { + fprintf(fdel, "Timestep %lld", update->ntimestep); + printflag = 1; + } + fprintf(fdel, " %g ", deletecount[m]); + for (j = 0; j < ntypes; j ++) { + int itemp = MolName[ntypes * m + j]; + if (itemp != 0) { + if (eletype) fprintf(fdel, "%s", eletype[j]); + else fprintf(fdel, "%c", ele[j]); + if (itemp != 1) fprintf(fdel, "%d", itemp); + } + } + } + } + if (printflag) { + fprintf(fdel, "\n"); + fflush(fdel); + } + } else { + int writeflag = 0; + for (i = 0; i < ndelspec; i++) + if (deletecount[i]) writeflag = 1; + + if (writeflag) { + fprintf(fdel, "%lld", update->ntimestep); + for (i = 0; i < ndelspec; i++) { + fprintf(fdel, "\t%g", deletecount[i]); + } + fprintf(fdel, "\n"); + fflush(fdel); + } + } + } + + if (ndel && (atom->map_style != Atom::MAP_NONE)) { + atom->nghost = 0; + atom->map_init(); + atom->map_set(); + } + + next_reneighbor = update->ntimestep; + + memory->destroy(Nameall); + memory->destroy(marklist); + memory->destroy(mark); + memory->destroy(deletecount); +} + +/* ---------------------------------------------------------------------- */ + double FixReaxFFSpecies::compute_vector(int n) { if (n == 0) return vector_nmole; diff --git a/src/REAXFF/fix_reaxff_species.h b/src/REAXFF/fix_reaxff_species.h index f441c3bc92..64d408ed24 100644 --- a/src/REAXFF/fix_reaxff_species.h +++ b/src/REAXFF/fix_reaxff_species.h @@ -45,19 +45,24 @@ class FixReaxFFSpecies : public Fix { protected: int me, nprocs, nmax, nlocal, ntypes, ntotal; - int nrepeat, nfreq, posfreq, compressed; + int nrepeat, nfreq, posfreq, compressed, ndelspec; int Nmoltype, vector_nmole, vector_nspec; - int *Name, *MolName, *NMol, *nd, *MolType, *molmap; + int *Name, *MolName, *NMol, *nd, *MolType, *molmap, *mark; + int *Mol2Spec; double *clusterID; AtomCoord *x0; double bg_cut; double **BOCut; - FILE *fp, *pos; + std::vector del_species; + + FILE *fp, *pos, *fdel; int eleflag, posflag, multipos, padflag, setupflag; - int singlepos_opened, multipos_opened; - char *ele, **eletype, *filepos; + int delflag, masslimitflag; + double massmin, massmax; + int singlepos_opened, multipos_opened, del_opened; + char *ele, **eletype, *filepos, *filedel; void Output_ReaxFF_Bonds(bigint, FILE *); AtomCoord chAnchor(AtomCoord, AtomCoord); @@ -65,6 +70,7 @@ class FixReaxFFSpecies : public Fix { void SortMolecule(int &); void FindSpecies(int, int &); void WriteFormulas(int, int); + void DeleteSpecies(int, int); int CheckExistence(int, int); int nint(const double &); From 204bba6ff70c5d8dab197265679cb9ba2a12e50a Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Fri, 10 Jun 2022 08:17:14 -0600 Subject: [PATCH 336/585] new options for fix mdi/aimd --- doc/src/fix_mdi_aimd.rst | 86 +++++++++++++++++++++++++++++----------- 1 file changed, 62 insertions(+), 24 deletions(-) diff --git a/doc/src/fix_mdi_aimd.rst b/doc/src/fix_mdi_aimd.rst index 64bc4a3d6a..76524e2721 100644 --- a/doc/src/fix_mdi_aimd.rst +++ b/doc/src/fix_mdi_aimd.rst @@ -1,6 +1,6 @@ -.. index:: fix mdi/aimd +.. index:: fix mdi/qm -fix mdi/aimd command +fix mdi/qm command ====================== Syntax @@ -8,11 +8,21 @@ Syntax .. parsed-literal:: - fix ID group-ID mdi/aimd keyword + fix ID group-ID mdi/qm keyword * ID, group-ID are documented in :doc:`fix ` command -* mdi/aimd = style name of this fix command -* optional keyword = *plugin* +* mdi/qm = style name of this fix command +* zero or more keyword/value pairs may be appended +* keyword = *plugin* or *add* of *every* + + .. parsed-literal:: + + *plugin* args = none + *add* args = *yes* or *no* + yes = add returned value from server code to LAMMPS quantities + no = do not add returned values to LAMMPS quantities + *every* args = Nevery + Nevery = request values from server code once every Nevery steps Examples """""""" @@ -26,17 +36,31 @@ Description """"""""""" This command enables LAMMPS to act as a client with another server -code to couple the two codes together to perform ab initio MD (AIMD) -simulations. +code that will compute the total energy, per-atom forces, and total +virial for conformations and box size/shape that LAMMPS sends it. -More specifically, this command causes LAMMPS to begin using the `MDI -Library `_ -to run as an MDI driver (client), which sends MDI commands to an -external MDI engine code (server) which in the case of AIMD is a -quantum mechanics (QM) code, or could be LAMMPS itself, acting as a -surrogate for a QM code. See the :doc:`Howto mdi ` page -for more information about how LAMMPS can operate as either an MDI -driver or engine. +Typically the server code will be a quantum code, hence the name of +the fix. However this is not required, the server code could be +another classical molecular dynamics code or LAMMPS itself. The +server code must support use of the `MDI Library +`_ as +explained below. + +Example use cases for this fix are the following (discussed further +below): + +* perform an ab intitio MD (AIMD) simulation with quantum forces +* perform an energy minimziation with quantum forces +* perform a nudged elatic band (NEB) calculation with quantum forces +* LAMMPS reads or creates a series of configurations and requests a QM calculation for each one + +The code coupling performed by this command is done via the `MDI +Library `_. +LAMMPS runs as an MDI driver (client), and sends MDI commands to an +external MDI engine code (server), e.g. a quantum code which has +support for MDI. See the :doc:`Howto mdi ` page for more +information about how LAMMPS can operate as either an MDI driver or +engine. The examples/mdi directory contains input scripts performing AIMD in this manner with LAMMPS acting as both a driver and an engine @@ -47,11 +71,18 @@ MDI could be used in place of LAMMPS acting as a QM surrogate. See the :doc:`Howto mdi ` page for a current list (March 2022) of such QM codes. -The engine code can run either as a stand-alone code, launched at the -same time as LAMMPS, or as a plugin library. See the :doc:`mdi plugin -` command for how to trigger LAMMPS to load the plugin library. -Again, the examples/mdi/README file explains how to launch both driver -and engine codes so that engine is used in plugin mode. +Engine codes can support MDI in either or both of two ways. The +engine code can support being used as a stand-alone code, launched at +the same time as LAMMPS. Or the engine code can support being used as +a plugin library, which LAMMPS loads. See the :doc:`mdi plugin ` +command for how to trigger LAMMPS to load the plugin library. The +examples/mdi/README file explains both use cases: launching both the +driver and engine as stand-alone codes or having the driver code load +an engine as a plugin library. + +---------- + + To use this fix with a plugin engine, you must specify the *plugin* keyword as the last argument, as illustrated above. @@ -63,7 +94,9 @@ To use this fix with a plugin engine, you must specify the ---------- -This fix performs the timestepping portion of an AIMD simulation. +---------- + +This fix performs the timestepping portion of anAIMD simulation. Both LAMMPS and the engine code (QM or LAMMPS) should define the same system (simulation box, atoms and their types) in their respective input scripts. LAMMPS then begins its timestepping. @@ -83,11 +116,15 @@ This command is part of the MDI package. It is only enabled if LAMMPS was built with that package. See the :doc:`Build package ` page for more info. +Stored values by fix: energy, per-atoms forces, virial. + + + To use LAMMPS as an MDI driver in conjunction with other MDI-enabled atomistic codes, the :doc:`units ` command should be used to specify *real* or *metal* units. This will ensure the correct unit -conversions between LAMMPS and MDI units, which the other codes will -also perform in their preferred units. +conversions between LAMMPS and MDI units. The other code will also +perform similar unit conversions into its preferred units. LAMMPS can also be used as an MDI driver in other unit choices it supports, e.g. *lj*, but then no unit conversion is performed. @@ -100,4 +137,5 @@ Related commands Default """"""" -none +The default for the optional keywords is add = yes, every = 1. + From ac48852b2d02005d1f92504a7d6474d4cdb808f7 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Fri, 10 Jun 2022 08:30:23 -0600 Subject: [PATCH 337/585] edits to 1st paragraph of description --- doc/src/compute_ave_sphere_atom.rst | 64 ++++++++++++++++------------- 1 file changed, 36 insertions(+), 28 deletions(-) diff --git a/doc/src/compute_ave_sphere_atom.rst b/doc/src/compute_ave_sphere_atom.rst index a6607356c9..48dbf377cb 100644 --- a/doc/src/compute_ave_sphere_atom.rst +++ b/doc/src/compute_ave_sphere_atom.rst @@ -35,18 +35,24 @@ Examples Description """"""""""" -Define a computation that calculates the local mass density and temperature -for each atom and neighbors inside a spherical cutoff. The center-of-mass -velocity of the atoms in the sphere is subtracted out before computing the -temperature, which leaves only the thermal velocity, similar to :doc:`compute temp/com `. +Define a computation that calculates the local mass density and +temperature for each atom based on its neighbors inside a spherical +cutoff. If an atom has M neighbors, then its local mass density is +calculated as the sum of its mass and its M neighbor masses, divided +by the volume of the cutoff sphere (or circle in 2d). The local +temperature of the atom is calculated as the temperature of the +collection of M+1 atoms, after subtracting the center-of-mass velocity +of the M+1 atoms from each of the M+1 atom's velocities. This is +effectively the thermal velocity of the neighborhood of the central +atom, similar to :doc:`compute temp/com `. -The optional keyword *cutoff* defines the distance cutoff -used when searching for neighbors. The default value is the cutoff -specified by the pair style. If no pair style is defined, then a cutoff -must be defined using this keyword. If the specified cutoff is larger than -that of the pair_style plus neighbor skin (or no pair style is defined), -the *comm_modify cutoff* option must also be set to match that of the -*cutoff* keyword. +The optional keyword *cutoff* defines the distance cutoff used when +searching for neighbors. The default value is the cutoff specified by +the pair style. If no pair style is defined, then a cutoff must be +defined using this keyword. If the specified cutoff is larger than +that of the pair_style plus neighbor skin (or no pair style is +defined), the *comm_modify cutoff* option must also be set to match +that of the *cutoff* keyword. The neighbor list needed to compute this quantity is constructed each time the calculation is performed (i.e. each time a snapshot of atoms @@ -57,16 +63,16 @@ too frequently. If you have a bonded system, then the settings of :doc:`special_bonds ` command can remove pairwise - interactions between atoms in the same bond, angle, or dihedral. This - is the default setting for the :doc:`special_bonds ` - command, and means those pairwise interactions do not appear in the - neighbor list. Because this compute uses the neighbor list, it also means - those pairs will not be included in the order parameter. This - difficulty can be circumvented by writing a dump file, and using the - :doc:`rerun ` command to compute the order parameter for - snapshots in the dump file. The rerun script can use a - :doc:`special_bonds ` command that includes all pairs in - the neighbor list. + interactions between atoms in the same bond, angle, or dihedral. + This is the default setting for the :doc:`special_bonds + ` command, and means those pairwise interactions do + not appear in the neighbor list. Because this compute uses the + neighbor list, it also means those pairs will not be included in + the order parameter. This difficulty can be circumvented by + writing a dump file, and using the :doc:`rerun ` command to + compute the order parameter for snapshots in the dump file. The + rerun script can use a :doc:`special_bonds ` command + that includes all pairs in the neighbor list. ---------- @@ -79,18 +85,20 @@ too frequently. Output info """"""""""" -This compute calculates a per-atom array with two columns: mass density in density -:doc:`units ` and temperature in temperature :doc:`units `. +This compute calculates a per-atom array with two columns: mass +density in density :doc:`units ` and temperature in temperature +:doc:`units `. These values can be accessed by any command that uses per-atom values -from a compute as input. See the :doc:`Howto output ` doc -page for an overview of LAMMPS output options. +from a compute as input. See the :doc:`Howto output ` +doc page for an overview of LAMMPS output options. Restrictions """""""""""" -This compute is part of the EXTRA-COMPUTE package. It is only enabled if -LAMMPS was built with that package. See the :doc:`Build package ` page for more info. +This compute is part of the EXTRA-COMPUTE package. It is only enabled +if LAMMPS was built with that package. See the :doc:`Build package +` page for more info. Related commands """""""""""""""" @@ -100,5 +108,5 @@ Related commands Default """"""" -The option defaults are *cutoff* = pair style cutoff +The option defaults are *cutoff* = pair style cutoff. From ed702aab0539e0b4749ae24b3c36d3ac03dc87ad Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 10 Jun 2022 13:00:36 -0400 Subject: [PATCH 338/585] update for renamed style names --- src/.gitignore | 8 ++++---- 1 file changed, 4 insertions(+), 4 deletions(-) diff --git a/src/.gitignore b/src/.gitignore index de157734fc..220cd621db 100644 --- a/src/.gitignore +++ b/src/.gitignore @@ -997,8 +997,8 @@ /neb.h /netcdf_units.cpp /netcdf_units.h -/pair_3b_table.cpp -/pair_3b_table.h +/pair_threebody_table.cpp +/pair_threebody_table.h /pair_adp.cpp /pair_adp.h /pair_agni.cpp @@ -1293,8 +1293,8 @@ /pair_sph_taitwater_morris.h /pair_sw.cpp /pair_sw.h -/pair_sw_3b_table.cpp -/pair_sw_3b_table.h +/pair_sw_angle_table.cpp +/pair_sw_angle_table.h /pair_sw_mod.cpp /pair_sw_mod.h /pair_tersoff.cpp From 8346ae2565ecd51f9d12639aec85285e4a3ab86d Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Fri, 10 Jun 2022 15:32:41 -0600 Subject: [PATCH 339/585] more edits --- doc/src/fix_mdi_aimd.rst | 39 ++++++++++++++++++--------------------- 1 file changed, 18 insertions(+), 21 deletions(-) diff --git a/doc/src/fix_mdi_aimd.rst b/doc/src/fix_mdi_aimd.rst index 76524e2721..7b87f369d7 100644 --- a/doc/src/fix_mdi_aimd.rst +++ b/doc/src/fix_mdi_aimd.rst @@ -13,16 +13,16 @@ Syntax * ID, group-ID are documented in :doc:`fix ` command * mdi/qm = style name of this fix command * zero or more keyword/value pairs may be appended -* keyword = *plugin* or *add* of *every* +* keyword = *plugin* or *every* or *add* .. parsed-literal:: - *plugin* args = none + *plugin* args = none + *every* args = Nevery + Nevery = request values from server code once every Nevery steps *add* args = *yes* or *no* yes = add returned value from server code to LAMMPS quantities no = do not add returned values to LAMMPS quantities - *every* args = Nevery - Nevery = request values from server code once every Nevery steps Examples """""""" @@ -37,7 +37,8 @@ Description This command enables LAMMPS to act as a client with another server code that will compute the total energy, per-atom forces, and total -virial for conformations and box size/shape that LAMMPS sends it. +virial for atom conformations and simulation box size/shapes that +LAMMPS sends it. Typically the server code will be a quantum code, hence the name of the fix. However this is not required, the server code could be @@ -52,7 +53,7 @@ below): * perform an ab intitio MD (AIMD) simulation with quantum forces * perform an energy minimziation with quantum forces * perform a nudged elatic band (NEB) calculation with quantum forces -* LAMMPS reads or creates a series of configurations and requests a QM calculation for each one +* requests a QM calculation for a series of independent systems which LAMMPS reads or generates The code coupling performed by this command is done via the `MDI Library `_. @@ -62,23 +63,23 @@ support for MDI. See the :doc:`Howto mdi ` page for more information about how LAMMPS can operate as either an MDI driver or engine. -The examples/mdi directory contains input scripts performing AIMD in -this manner with LAMMPS acting as both a driver and an engine +The examples/mdi directory contains input scripts using this fix, with +two instances of LAMMPS acting as both a driver and an engine (surrogate for a QM code). The examples/mdi/README file explains how -to launch both driver and engine codes so that they communicate using +to launch two driver and engine codes so that they communicate using the MDI library via either MPI or sockets. Any QM code that supports MDI could be used in place of LAMMPS acting as a QM surrogate. See the :doc:`Howto mdi ` page for a current list (March 2022) of such QM codes. -Engine codes can support MDI in either or both of two ways. The -engine code can support being used as a stand-alone code, launched at -the same time as LAMMPS. Or the engine code can support being used as -a plugin library, which LAMMPS loads. See the :doc:`mdi plugin ` -command for how to trigger LAMMPS to load the plugin library. The -examples/mdi/README file explains both use cases: launching both the -driver and engine as stand-alone codes or having the driver code load -an engine as a plugin library. +Engine codes can support MDI in either or both of two ways. It can +support being used as a stand-alone code, launched at the same time as +LAMMPS. Or it can support being used as a plugin library, which +LAMMPS loads. See the :doc:`mdi plugin ` command for how to +trigger LAMMPS to load the plugin library. The examples/mdi/README +file explains both use cases: launching both the driver and engine as +stand-alone codes or having the driver code load an engine as a plugin +library. ---------- @@ -87,10 +88,6 @@ an engine as a plugin library. To use this fix with a plugin engine, you must specify the *plugin* keyword as the last argument, as illustrated above. -.. note:: - - As of April 2022, the *plugin* keyword is needed. In a future - version of the MDI library it will no longer be necessary. ---------- From ef48fd2d9ce71163a418412aa0423a985bf6058f Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sun, 12 Jun 2022 23:36:43 -0400 Subject: [PATCH 340/585] remove unused imports --- examples/ELASTIC_T/BORN_MATRIX/Silicon/elastic_utils.py | 2 +- python/install.py | 2 +- 2 files changed, 2 insertions(+), 2 deletions(-) diff --git a/examples/ELASTIC_T/BORN_MATRIX/Silicon/elastic_utils.py b/examples/ELASTIC_T/BORN_MATRIX/Silicon/elastic_utils.py index 0daf62b1b0..2307f3d413 100644 --- a/examples/ELASTIC_T/BORN_MATRIX/Silicon/elastic_utils.py +++ b/examples/ELASTIC_T/BORN_MATRIX/Silicon/elastic_utils.py @@ -1,5 +1,5 @@ import numpy as np -from lammps import lammps, LAMMPS_INT, LMP_STYLE_GLOBAL, LMP_VAR_EQUAL, LMP_VAR_ATOM +from lammps import lammps, LMP_VAR_EQUAL # method for rotating elastic constants diff --git a/python/install.py b/python/install.py index 03b3366ba6..e3a4dc9251 100644 --- a/python/install.py +++ b/python/install.py @@ -11,7 +11,7 @@ independently and used to build the wheel without installing it. """ from __future__ import print_function -import sys,os,shutil,time,glob,subprocess +import sys,os,shutil,glob,subprocess from argparse import ArgumentParser parser = ArgumentParser(prog='install.py', From 9ac17d2ff8d77c27408299c1c64c1ed3a9cd7e2b Mon Sep 17 00:00:00 2001 From: Evan Weinberg Date: Mon, 13 Jun 2022 09:19:24 -0700 Subject: [PATCH 341/585] Commit of Pair MEAM WIP Kokkos port. Currently compiles but does not work. --- src/Depend.sh | 4 + src/KOKKOS/Install.sh | 9 + src/KOKKOS/math_special_kokkos.h | 12 + src/KOKKOS/meam_dens_final_kokkos.h | 181 ++++++++ src/KOKKOS/meam_dens_init_kokkos.h | 554 ++++++++++++++++++++++++ src/KOKKOS/meam_force_kokkos.h | 554 ++++++++++++++++++++++++ src/KOKKOS/meam_funcs_kokkos.h | 326 ++++++++++++++ src/KOKKOS/meam_impl_kokkos.h | 72 ++++ src/KOKKOS/meam_kokkos.h | 142 +++++++ src/KOKKOS/meam_setup_done_kokkos.h | 71 ++++ src/KOKKOS/pair_meam_kokkos.cpp | 633 ++++++++++++++++++++++++++++ src/KOKKOS/pair_meam_kokkos.h | 166 ++++++++ src/MEAM/meam.h | 2 +- src/MEAM/pair_meam.cpp | 2 + src/MEAM/pair_meam.h | 4 +- 15 files changed, 2729 insertions(+), 3 deletions(-) create mode 100644 src/KOKKOS/meam_dens_final_kokkos.h create mode 100644 src/KOKKOS/meam_dens_init_kokkos.h create mode 100644 src/KOKKOS/meam_force_kokkos.h create mode 100644 src/KOKKOS/meam_funcs_kokkos.h create mode 100644 src/KOKKOS/meam_impl_kokkos.h create mode 100644 src/KOKKOS/meam_kokkos.h create mode 100644 src/KOKKOS/meam_setup_done_kokkos.h create mode 100644 src/KOKKOS/pair_meam_kokkos.cpp create mode 100644 src/KOKKOS/pair_meam_kokkos.h diff --git a/src/Depend.sh b/src/Depend.sh index 8046fd2636..98f3e5de4f 100755 --- a/src/Depend.sh +++ b/src/Depend.sh @@ -127,6 +127,10 @@ if (test $1 = "MANYBODY") then depend OPENMP fi +if (test $1 = "MEAM") then + depend KOKKOS +fi + if (test $1 = "MOLECULE") then depend EXTRA-MOLECULE depend GPU diff --git a/src/KOKKOS/Install.sh b/src/KOKKOS/Install.sh index 022da7855a..952f21e403 100755 --- a/src/KOKKOS/Install.sh +++ b/src/KOKKOS/Install.sh @@ -207,6 +207,13 @@ action nbin_ssa_kokkos.cpp nbin_ssa.cpp action nbin_ssa_kokkos.h nbin_ssa.h action math_special_kokkos.cpp action math_special_kokkos.h +action meam_setup_done_kokkos.h meam_setup_done.cpp +action meam_kokkos.h meam.h +action meam_impl_kokkos.h meam_impl.cpp +action meam_funcs_kokkos.h meam_funcs.cpp +action meam_force_kokkos.h meam_force.cpp +action meam_dens_init_kokkos.h meam_dens_init.cpp +action meam_dens_final_kokkos.h meam_dens_final.cpp action min_cg_kokkos.cpp action min_cg_kokkos.h action min_kokkos.cpp @@ -287,6 +294,8 @@ action pair_lj_gromacs_kokkos.cpp pair_lj_gromacs.cpp action pair_lj_gromacs_kokkos.h pair_lj_gromacs.h action pair_lj_sdk_kokkos.cpp pair_lj_sdk.cpp action pair_lj_sdk_kokkos.h pair_lj_sdk.h +action pair_meam_kokkos.h pair_meam.h +action pair_meam_kokkos.cpp pair_meam.cpp action pair_morse_kokkos.cpp action pair_morse_kokkos.h action pair_multi_lucy_rx_kokkos.cpp pair_multi_lucy_rx.cpp diff --git a/src/KOKKOS/math_special_kokkos.h b/src/KOKKOS/math_special_kokkos.h index 802d1c2979..f2d23a65eb 100644 --- a/src/KOKKOS/math_special_kokkos.h +++ b/src/KOKKOS/math_special_kokkos.h @@ -50,6 +50,18 @@ namespace MathSpecialKokkos { #endif } +#define FM_DOUBLE_LOG2OFE 1.4426950408889634074 + // fast e**x function for little endian CPUs, falls back to libc on other platforms + KOKKOS_INLINE_FUNCTION + static double fm_exp(double x) + { +#if defined(__BYTE_ORDER__) && (__BYTE_ORDER__ == __ORDER_LITTLE_ENDIAN__) + return exp2_x86(FM_DOUBLE_LOG2OFE * x); +#else + return ::exp(x); +#endif + } + // x**2, use instead of pow(x,2.0) KOKKOS_INLINE_FUNCTION static double square(const double &x) { return x*x; } diff --git a/src/KOKKOS/meam_dens_final_kokkos.h b/src/KOKKOS/meam_dens_final_kokkos.h new file mode 100644 index 0000000000..b44a8af3bd --- /dev/null +++ b/src/KOKKOS/meam_dens_final_kokkos.h @@ -0,0 +1,181 @@ +#include "meam_kokkos.h" +#include "math_special.h" + +using namespace LAMMPS_NS; + +template +void +MEAMKokkos::meam_dens_final(int nlocal, int eflag_either, int eflag_global, int eflag_atom, double* eng_vdwl, + typename ArrayTypes::t_efloat_1d eatom, int ntype, typename AT::t_int_1d_randomread type, typename AT::t_int_1d_randomread fmap, int& errorflag) +{ + EV_FLOAT ev; + ev.evdwl = *eng_vdwl; + this->eflag_either = eflag_either; + this->eflag_global = eflag_global; + this->eflag_atom = eflag_atom; + this->d_eatom = eatom; + this->ntype = ntype; + this->type = type; + this->fmap = fmap; + + // Complete the calculation of density + + Kokkos::parallel_reduce(Kokkos::RangePolicy(0,nlocal),*this,ev); + *eng_vdwl = ev.evdwl; +} + +template +KOKKOS_INLINE_FUNCTION +void MEAMKokkos::operator()(TagMEAMDensFinal, const int &i, EV_FLOAT& ev) const { + + lattice_t elti; + int m; + int errorflag; + F_FLOAT rhob, G, dG, Gbar, dGbar, gam, shp[3], Z; + F_FLOAT B, denom, rho_bkgd; + + // may or may not be legal + elti = static_cast(fmap[type[i]]); + if (elti >= 0) { + d_rho1[i] = 0.0; + d_rho2[i] = -1.0 / 3.0 * d_arho2b[i] * d_arho2b[i]; + d_rho3[i] = 0.0; + for (m = 0; m < 3; m++) { + d_rho1[i] = d_rho1[i] + d_arho1(i,m) * d_arho1(i,m); + d_rho3[i] = d_rho3[i] - 3.0 / 5.0 * d_arho3b(i,m) * d_arho3b(i,m); + } + for (m = 0; m < 6; m++) { + d_rho2[i] = d_rho2[i] + v2D[m] * d_arho2(i,m) * d_arho2(i,m); + } + for (m = 0; m < 10; m++) { + d_rho3[i] = d_rho3[i] + v3D[m] * d_arho3(i,m) * d_arho3(i,m); + } + + if (d_rho0[i] > 0.0) { + if (this->ialloy == 1) { + d_t_ave(i,0) = fdiv_zero_kk(d_t_ave(i,0), d_tsq_ave(i,0)); + d_t_ave(i,1) = fdiv_zero_kk(d_t_ave(i,1), d_tsq_ave(i,1)); + d_t_ave(i,2) = fdiv_zero_kk(d_t_ave(i,2), d_tsq_ave(i,2)); + } else if (this->ialloy == 2) { + d_t_ave(i,0) = this->t1_meam[elti]; + d_t_ave(i,1) = this->t2_meam[elti]; + d_t_ave(i,2) = this->t3_meam[elti]; + } else { + d_t_ave(i,0) = d_t_ave(i,0) / d_rho0[i]; + d_t_ave(i,1) = d_t_ave(i,1) / d_rho0[i]; + d_t_ave(i,2) = d_t_ave(i,2) / d_rho0[i]; + } + } + + d_gamma[i] = d_t_ave(i,0) * d_rho1[i] + d_t_ave(i,1) * d_rho2[i] + d_t_ave(i,2) * d_rho3[i]; + + if (d_rho0[i] > 0.0) { + d_gamma[i] = d_gamma[i] / (d_rho0[i] * d_rho0[i]); + } + + // need to double check, the analogous function is + // Z = get_Zij(this->lattce_meam[elti][elti]); in the non-KOKKOS version? + Z = get_Zij(elti); + + G = G_gam(d_gamma[i], this->ibar_meam[elti], errorflag); + if (errorflag != 0) + { + //char str[128]; + //sprintf(str,"MEAMKokkos library error %d",errorflag); + //error->one(FLERR,str); + return; + } + get_shpfcn(this->lattce_meam[elti][elti], shp); + if (this->ibar_meam[elti] <= 0) { + Gbar = 1.0; + dGbar = 0.0; + } else { + if (this->mix_ref_t == 1) { + gam = (d_t_ave(i,0) * shp[0] + d_t_ave(i,1) * shp[1] + d_t_ave(i,2) * shp[2]) / (Z * Z); + } else { + gam = (this->t1_meam[elti] * shp[0] + this->t2_meam[elti] * shp[1] + this->t3_meam[elti] * shp[2]) / + (Z * Z); + } + Gbar = G_gam(gam, this->ibar_meam[elti], errorflag); + } + d_rho[i] = d_rho0[i] * G; + + if (this->mix_ref_t == 1) { + if (this->ibar_meam[elti] <= 0) { + Gbar = 1.0; + dGbar = 0.0; + } else { + gam = (d_t_ave(i,0) * shp[0] + d_t_ave(i,1) * shp[1] + d_t_ave(i,2) * shp[2]) / (Z * Z); + Gbar = dG_gam(gam, this->ibar_meam[elti], dGbar); + } + rho_bkgd = this->rho0_meam[elti] * Z * Gbar; + } else { + if (this->bkgd_dyn == 1) { + rho_bkgd = this->rho0_meam[elti] * Z; + } else { + rho_bkgd = this->rho_ref_meam[elti]; + } + } + rhob = d_rho[i] / rho_bkgd; + denom = 1.0 / rho_bkgd; + + G = dG_gam(d_gamma[i], this->ibar_meam[elti], dG); + + d_dgamma1[i] = (G - 2 * dG * d_gamma[i]) * denom; + + if (!iszero_kk(d_rho0[i])) { + d_dgamma2[i] = (dG / d_rho0[i]) * denom; + } else { + d_dgamma2[i] = 0.0; + } + + // dgamma3 is nonzero only if we are using the "mixed" rule for + // computing t in the reference system (which is not correct, but + // included for backward compatibility + if (this->mix_ref_t == 1) { + d_dgamma3[i] = d_rho0[i] * G * dGbar / (Gbar * Z * Z) * denom; + } else { + d_dgamma3[i] = 0.0; + } + + B = this->A_meam[elti] * this->Ec_meam[elti][elti]; + + if (!iszero_kk(rhob)) { + if (this->emb_lin_neg == 1 && rhob <= 0) { + d_frhop[i] = -B; + } else { + d_frhop[i] = B * (log(rhob) + 1.0); + } + if (eflag_either != 0) { + if (eflag_global != 0) { + if (this->emb_lin_neg == 1 && rhob <= 0) { + //*eng_vdwl = *eng_vdwl - B * rhob; + ev.evdwl = ev.evdwl - B * rhob; + } else { + //*eng_vdwl = *eng_vdwl + B * rhob * log(rhob); + ev.evdwl = ev.evdwl + B * rhob * log(rhob); + } + } + if (eflag_atom != 0) { + if (this->emb_lin_neg == 1 && rhob <= 0) { + d_eatom[i] = d_eatom[i] - B * rhob; + } else { + d_eatom[i] = d_eatom[i] + B * rhob * log(rhob); + } + } + } + } else { + if (this->emb_lin_neg == 1) { + d_frhop[i] = -B; + } else { + d_frhop[i] = B; + } + } + } + if (errorflag) + { + //char str[128]; + //sprintf(str,"MEAMKokkos library error %d",errorflag); + //error->one(FLERR,str); + } +} diff --git a/src/KOKKOS/meam_dens_init_kokkos.h b/src/KOKKOS/meam_dens_init_kokkos.h new file mode 100644 index 0000000000..c3dfdbbcb8 --- /dev/null +++ b/src/KOKKOS/meam_dens_init_kokkos.h @@ -0,0 +1,554 @@ +#include "meam_kokkos.h" +#include "math_special.h" +#include "mpi.h" + +using namespace LAMMPS_NS; +using namespace MathSpecialKokkos; + +template +template +KOKKOS_INLINE_FUNCTION +void MEAMKokkos::operator()(TagMEAMDensInit, const int &i, EV_FLOAT &ev) const { + int ii, offsetval; + ii = d_ilist_half[i]; + offsetval = d_offset[i]; + // Compute screening function and derivatives + this->template getscreen(ii, offsetval, x, d_numneigh_half, + d_numneigh_full, ntype, type, fmap); + + // Calculate intermediate density terms to be communicated + this->template calc_rho1(ii, ntype, type, fmap, x, d_numneigh_half, offsetval); + ev.evdwl += d_numneigh_half[i]; +} + +template +KOKKOS_INLINE_FUNCTION +void MEAMKokkos::operator()(TagMEAMInitialize, const int &i) const { + d_rho0[i] = 0.0; + d_arho2b[i] = 0.0; + d_arho1(i,0) = d_arho1(i,1) = d_arho1(i,2) = 0.0; + for (int j = 0; j < 6; j++) + d_arho2(i,j) = 0.0; + for (int j = 0; j < 10; j++) + d_arho3(i,j) = 0.0; + d_arho3b(i,0) = d_arho3b(i,1) = d_arho3b(i,2) = 0.0; + d_t_ave(i,0) = d_t_ave(i,1) = d_t_ave(i,2) = 0.0; + d_tsq_ave(i,0) = d_tsq_ave(i,1) = d_tsq_ave(i,2) = 0.0; +} + +template +void +MEAMKokkos::meam_dens_setup(int atom_nmax, int nall, int n_neigh) +{ + MemoryKokkos *memoryKK = (MemoryKokkos *)memory; + + // grow local arrays if necessary + + if (atom_nmax > nmax) { + memoryKK->destroy_kokkos(k_rho,rho); + memoryKK->destroy_kokkos(k_rho0,rho0); + memoryKK->destroy_kokkos(k_rho1,rho1); + memoryKK->destroy_kokkos(k_rho2,rho2); + memoryKK->destroy_kokkos(k_rho3,rho3); + memoryKK->destroy_kokkos(k_frhop,frhop); + memoryKK->destroy_kokkos(k_gamma,gamma); + memoryKK->destroy_kokkos(k_dgamma1,dgamma1); + memoryKK->destroy_kokkos(k_dgamma2,dgamma2); + memoryKK->destroy_kokkos(k_dgamma3,dgamma3); + memoryKK->destroy_kokkos(k_arho2b,arho2b); + memoryKK->destroy_kokkos(k_arho1,arho1); + memoryKK->destroy_kokkos(k_arho2,arho2); + memoryKK->destroy_kokkos(k_arho3,arho3); + memoryKK->destroy_kokkos(k_arho3b,arho3b); + memoryKK->destroy_kokkos(k_t_ave,t_ave); + memoryKK->destroy_kokkos(k_tsq_ave,tsq_ave); + + nmax = atom_nmax; +// memory->create(rho, nmax, "pair:rho"); + k_rho = DAT::tdual_ffloat_1d("pair:rho",nmax); + d_rho = k_rho.template view(); + h_rho = k_rho.h_view; + // memory->create(rho0, nmax, "pair:rho0"); + k_rho0 = DAT::tdual_ffloat_1d("pair:rho0",nmax); + d_rho0 = k_rho0.template view(); + h_rho0 = k_rho0.h_view; + //memory->create(rho1, nmax, "pair:rho1"); + k_rho1 = DAT::tdual_ffloat_1d("pair:rho1",nmax); + d_rho1 = k_rho1.template view(); + h_rho1 = k_rho1.h_view; + //memory->create(rho2, nmax, "pair:rho2"); + k_rho2 = DAT::tdual_ffloat_1d("pair:rho2",nmax); + d_rho2 = k_rho2.template view(); + h_rho2 = k_rho2.h_view; + //memory->create(rho3, nmax, "pair:rho3"); + k_rho3 = DAT::tdual_ffloat_1d("pair:rho3",nmax); + d_rho3 = k_rho3.template view(); + h_rho3 = k_rho3.h_view; + //memory->create(frhop, nmax, "pair:frhop"); + k_frhop = DAT::tdual_ffloat_1d("pair:frhop",nmax); + d_frhop = k_frhop.template view(); + h_frhop = k_frhop.h_view; + //memory->create(gamma, nmax, "pair:gamma"); + k_gamma = DAT::tdual_ffloat_1d("pair:gamma",nmax); + d_gamma = k_gamma.template view(); + h_gamma = k_gamma.h_view; + //memory->create(dgamma1, nmax, "pair:dgamma1"); + k_dgamma1 = DAT::tdual_ffloat_1d("pair:dgamma1",nmax); + d_dgamma1 = k_dgamma1.template view(); + h_dgamma1 = k_dgamma1.h_view; + //memory->create(dgamma2, nmax, "pair:dgamma2"); + k_dgamma2 = DAT::tdual_ffloat_1d("pair:dgamma2",nmax); + d_dgamma2 = k_dgamma2.template view(); + h_dgamma2 = k_dgamma2.h_view; + //memory->create(dgamma3, nmax, "pair:dgamma3"); + k_dgamma3 = DAT::tdual_ffloat_1d("pair:dgamma3",nmax); + d_dgamma3 = k_dgamma3.template view(); + h_dgamma3 = k_dgamma3.h_view; + //memory->create(arho2b, nmax, "pair:arho2b"); + k_arho2b = DAT::tdual_ffloat_1d("pair:arho2b",nmax); + d_arho2b = k_arho2b.template view(); + h_arho2b = k_arho2b.h_view; + //memory->create(arho1, nmax, 3, "pair:arho1"); + k_arho1 = DAT::tdual_ffloat_2d("pair:arho1",nmax, 3); + d_arho1 = k_arho1.template view(); + h_arho1 = k_arho1.h_view; + //memory->create(arho2, nmax, 6, "pair:arho2"); + k_arho2 = DAT::tdual_ffloat_2d("pair:arho2",nmax, 6); + d_arho2 = k_arho2.template view(); + h_arho2 = k_arho2.h_view; + //memory->create(arho3, nmax, 10, "pair:arho3"); + k_arho3 = DAT::tdual_ffloat_2d("pair:arho3",nmax, 10); + d_arho3 = k_arho3.template view(); + h_arho3 = k_arho3.h_view; + //memory->create(arho3b, nmax, 3, "pair:arho3b"); + k_arho3b = DAT::tdual_ffloat_2d("pair:arho3b",nmax, 3); + d_arho3b = k_arho3b.template view(); + h_arho3b = k_arho3b.h_view; + //memory->create(t_ave, nmax, 3, "pair:t_ave"); + k_t_ave = DAT::tdual_ffloat_2d("pair:t_ave",nmax, 3); + d_t_ave = k_t_ave.template view(); + h_t_ave = k_t_ave.h_view; + //memory->create(tsq_ave, nmax, 3, "pair:tsq_ave"); + k_tsq_ave = DAT::tdual_ffloat_2d("pair:tsq_ave",nmax, 3); + d_tsq_ave = k_tsq_ave.template view(); + h_tsq_ave = k_tsq_ave.h_view; + } + + if (n_neigh > maxneigh) { + memoryKK->destroy_kokkos(k_scrfcn,scrfcn); + memoryKK->destroy_kokkos(k_dscrfcn,dscrfcn); + memoryKK->destroy_kokkos(k_fcpair,fcpair); + maxneigh = n_neigh; + // memory->create(scrfcn, maxneigh, "pair:scrfcn"); + k_scrfcn = DAT::tdual_ffloat_1d("pair:scrfcn", maxneigh); + d_scrfcn = k_scrfcn.template view(); + h_scrfcn = k_scrfcn.h_view; + //memory->create(dscrfcn, maxneigh, "pair:dscrfcn"); + k_dscrfcn = DAT::tdual_ffloat_1d("pair:dscrfcn", maxneigh); + d_dscrfcn = k_dscrfcn.template view(); + h_dscrfcn = k_dscrfcn.h_view; + //memory->create(fcpair, maxneigh, "pair:fcpair"); + k_fcpair = DAT::tdual_ffloat_1d("pair:fcpair", maxneigh); + d_fcpair = k_fcpair.template view(); + h_fcpair = k_fcpair.h_view; + } + + // zero out local arrays + + Kokkos::parallel_for(Kokkos::RangePolicy(0, nall),*this); +} + +template +void +MEAMKokkos::meam_dens_init(int inum_half, int ntype, typename AT::t_int_1d_randomread type, typename AT::t_int_1d_randomread fmap, typename AT::t_x_array_randomread x, typename AT::t_int_1d_randomread d_numneigh_half, typename AT::t_int_1d_randomread d_numneigh_full, + int *fnoffset, typename AT::t_int_1d_randomread d_ilist_half, typename AT::t_neighbors_2d d_neighbors_half, typename AT::t_neighbors_2d d_neighbors_full, typename AT::t_int_1d_randomread d_offset, int neighflag) +{ + EV_FLOAT ev; + + ev.evdwl = 0; + this->ntype = ntype; + this->type = type; + this->fmap = fmap; + this->x = x; + this->d_numneigh_half = d_numneigh_half; + this->d_numneigh_full = d_numneigh_full; + this->d_ilist_half = d_ilist_half; + this->d_neighbors_half = d_neighbors_half; + this->d_neighbors_full = d_neighbors_full; + this->d_offset = d_offset; + if (neighflag == FULL) + Kokkos::parallel_reduce(Kokkos::RangePolicy >(0,inum_half),*this, ev); + else if (neighflag == HALF) + Kokkos::parallel_reduce(Kokkos::RangePolicy >(0,inum_half),*this, ev); + else if (neighflag == HALFTHREAD) + Kokkos::parallel_reduce(Kokkos::RangePolicy >(0,inum_half),*this, ev); + *fnoffset = (int)ev.evdwl; +} + +// ccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccc +template +template +KOKKOS_INLINE_FUNCTION +void +MEAMKokkos::getscreen(int i, int offset, typename AT::t_x_array_randomread x, typename AT::t_int_1d_randomread numneigh_half, + typename AT::t_int_1d_randomread numneigh_full, int /*ntype*/, typename AT::t_int_1d_randomread type, typename AT::t_int_1d_randomread fmap) +const { + int jn, j, kn, k; + int elti, eltj, eltk; + X_FLOAT xitmp, yitmp, zitmp, delxij, delyij, delzij; + F_FLOAT rij2, rij; + X_FLOAT xjtmp, yjtmp, zjtmp, delxik, delyik, delzik; + F_FLOAT rik2 /*,rik*/; + X_FLOAT xktmp, yktmp, zktmp, delxjk, delyjk, delzjk; + F_FLOAT rjk2 /*,rjk*/; + X_FLOAT xik, xjk; + F_FLOAT sij, fcij, sfcij, dfcij, sikj, dfikj, cikj; + F_FLOAT Cmin, Cmax, delc, /*ebound,*/ a, coef1, coef2; + F_FLOAT dCikj; + F_FLOAT rnorm, fc, dfc, drinv; + + drinv = 1.0 / this->delr_meam; + elti = fmap[type[i]]; + if (elti < 0) return; + + xitmp = x(i,0); + yitmp = x(i,1); + zitmp = x(i,2); + + for (jn = 0; jn < numneigh_half[i]; jn++) { + //j = firstneigh[jn]; + j = d_neighbors_half(i,jn); + + eltj = fmap[type[j]]; + if (eltj < 0) continue; + + // First compute screening function itself, sij + xjtmp = x(j,0); + yjtmp = x(j,1); + zjtmp = x(j,2); + delxij = xjtmp - xitmp; + delyij = yjtmp - yitmp; + delzij = zjtmp - zitmp; + + rij2 = delxij * delxij + delyij * delyij + delzij * delzij; + rij = sqrt(rij2); + + double rbound = this->ebound_meam[elti][eltj] * rij2; + if (rij > this->rc_meam) { + fcij = 0.0; + dfcij = 0.0; + sij = 0.0; + } else { + rnorm = (this->rc_meam - rij) * drinv; + sij = 1.0; + + // if rjk2 > ebound*rijsq, atom k is definitely outside the ellipse + for (kn = 0; kn < numneigh_full[i]; kn++) { + //k = firstneigh_full[kn]; + k = d_neighbors_full(i,kn); + eltk = fmap[type[k]]; + if (eltk < 0) continue; + if (k == j) continue; + + delxjk = x(k,0) - xjtmp; + delyjk = x(k,1) - yjtmp; + delzjk = x(k,2) - zjtmp; + rjk2 = delxjk * delxjk + delyjk * delyjk + delzjk * delzjk; + if (rjk2 > rbound) continue; + + delxik = x(k,0) - xitmp; + delyik = x(k,1) - yitmp; + delzik = x(k,2) - zitmp; + rik2 = delxik * delxik + delyik * delyik + delzik * delzik; + if (rik2 > rbound) continue; + + xik = rik2 / rij2; + xjk = rjk2 / rij2; + a = 1 - (xik - xjk) * (xik - xjk); + // if a < 0, then ellipse equation doesn't describe this case and + // atom k can't possibly screen i-j + if (a <= 0.0) continue; + + cikj = (2.0 * (xik + xjk) + a - 2.0) / a; + Cmax = this->Cmax_meam[elti][eltj][eltk]; + Cmin = this->Cmin_meam[elti][eltj][eltk]; + if (cikj >= Cmax) continue; + // note that cikj may be slightly negative (within numerical + // tolerance) if atoms are colinear, so don't reject that case here + // (other negative cikj cases were handled by the test on "a" above) + else if (cikj <= Cmin) { + sij = 0.0; + break; + } else { + delc = Cmax - Cmin; + cikj = (cikj - Cmin) / delc; + sikj = fcut(cikj); + } + sij *= sikj; + } + + fc = dfcut(rnorm, dfc); + fcij = fc; + dfcij = dfc * drinv; + } + // Now compute derivatives + d_dscrfcn[offset+jn] = 0.0; + sfcij = sij * fcij; + if (iszero_kk(sfcij) || iszero_kk(sfcij - 1.0)) + { + d_scrfcn[offset+jn] = sij; + d_fcpair[offset+jn] = fcij; + continue; + //goto LABEL_100; + } + + for (kn = 0; kn < numneigh_full[i]; kn++) { + //k = firstneigh_full[kn]; + k = d_neighbors_full(i,kn); + if (k == j) continue; + eltk = fmap[type[k]]; + if (eltk < 0) continue; + + xktmp = x(k,0); + yktmp = x(k,1); + zktmp = x(k,2); + delxjk = xktmp - xjtmp; + delyjk = yktmp - yjtmp; + delzjk = zktmp - zjtmp; + rjk2 = delxjk * delxjk + delyjk * delyjk + delzjk * delzjk; + if (rjk2 > rbound) continue; + + delxik = xktmp - xitmp; + delyik = yktmp - yitmp; + delzik = zktmp - zitmp; + rik2 = delxik * delxik + delyik * delyik + delzik * delzik; + if (rik2 > rbound) continue; + + xik = rik2 / rij2; + xjk = rjk2 / rij2; + a = 1 - (xik - xjk) * (xik - xjk); + // if a < 0, then ellipse equation doesn't describe this case and + // atom k can't possibly screen i-j + if (a <= 0.0) continue; + + cikj = (2.0 * (xik + xjk) + a - 2.0) / a; + Cmax = this->Cmax_meam[elti][eltj][eltk]; + Cmin = this->Cmin_meam[elti][eltj][eltk]; + if (cikj >= Cmax) { + continue; + // Note that cikj may be slightly negative (within numerical + // tolerance) if atoms are colinear, so don't reject that case + // here + // (other negative cikj cases were handled by the test on "a" + // above) + // Note that we never have 0 +template +KOKKOS_INLINE_FUNCTION +void +MEAMKokkos::calc_rho1(int i, int /*ntype*/, typename AT::t_int_1d_randomread type, typename AT::t_int_1d_randomread fmap, typename AT::t_x_array_randomread x, typename AT::t_int_1d_randomread numneigh, + int offset) const +{ + int jn, j, m, n, p, elti, eltj; + int nv2, nv3; + X_FLOAT xtmp, ytmp, ztmp, delij[3]; + F_FLOAT rij2, rij, sij; + F_FLOAT ai, aj, rhoa0j, rhoa1j, rhoa2j, rhoa3j, A1j, A2j, A3j; + // double G,Gbar,gam,shp[3+1]; + F_FLOAT ro0i, ro0j; + F_FLOAT rhoa0i, rhoa1i, rhoa2i, rhoa3i, A1i, A2i, A3i; + + // Likely to do: replace with duplicated view for OpenMP, atomic view for GPU abstraction + Kokkos::View::value> > a_rho0 = d_rho0; + Kokkos::View::value> > a_arho2b = d_arho2b; + Kokkos::View::value> > a_t_ave = d_t_ave; + Kokkos::View::value> > a_tsq_ave = d_tsq_ave; + Kokkos::View::value> > a_arho1 = d_arho1; + Kokkos::View::value> > a_arho2 = d_arho2; + Kokkos::View::value> > a_arho3 = d_arho3; + Kokkos::View::value> > a_arho3b = d_arho3b; + + elti = fmap[type[i]]; + xtmp = x(i,0); + ytmp = x(i,1); + ztmp = x(i,2); + for (jn = 0; jn < numneigh[i]; jn++) { + if (!iszero_kk(d_scrfcn[offset+jn])) { + //j = firstneigh[jn]; + j = d_neighbors_half(i,jn); + sij = d_scrfcn[offset+jn] * d_fcpair[offset+jn]; + delij[0] = x(j,0) - xtmp; + delij[1] = x(j,1) - ytmp; + delij[2] = x(j,2) - ztmp; + rij2 = delij[0] * delij[0] + delij[1] * delij[1] + delij[2] * delij[2]; + if (rij2 < this->cutforcesq) { + eltj = fmap[type[j]]; + rij = sqrt(rij2); + ai = rij / this->re_meam[elti][elti] - 1.0; + aj = rij / this->re_meam[eltj][eltj] - 1.0; + ro0i = this->rho0_meam[elti]; + ro0j = this->rho0_meam[eltj]; + rhoa0j = ro0j * MathSpecialKokkos::fm_exp(-this->beta0_meam[eltj] * aj) * sij; + rhoa1j = ro0j * MathSpecialKokkos::fm_exp(-this->beta1_meam[eltj] * aj) * sij; + rhoa2j = ro0j * MathSpecialKokkos::fm_exp(-this->beta2_meam[eltj] * aj) * sij; + rhoa3j = ro0j * MathSpecialKokkos::fm_exp(-this->beta3_meam[eltj] * aj) * sij; + rhoa0i = ro0i * MathSpecialKokkos::fm_exp(-this->beta0_meam[elti] * ai) * sij; + rhoa1i = ro0i * MathSpecialKokkos::fm_exp(-this->beta1_meam[elti] * ai) * sij; + rhoa2i = ro0i * MathSpecialKokkos::fm_exp(-this->beta2_meam[elti] * ai) * sij; + rhoa3i = ro0i * MathSpecialKokkos::fm_exp(-this->beta3_meam[elti] * ai) * sij; + if (this->ialloy == 1) { + rhoa1j = rhoa1j * this->t1_meam[eltj]; + rhoa2j = rhoa2j * this->t2_meam[eltj]; + rhoa3j = rhoa3j * this->t3_meam[eltj]; + rhoa1i = rhoa1i * this->t1_meam[elti]; + rhoa2i = rhoa2i * this->t2_meam[elti]; + rhoa3i = rhoa3i * this->t3_meam[elti]; + } + a_rho0[i] += rhoa0j; + a_rho0[j] += rhoa0i; + // For ialloy = 2, use single-element value (not average) + if (this->ialloy != 2) { + a_t_ave(i,0) = a_t_ave(i,0) + this->t1_meam[eltj] * rhoa0j; + a_t_ave(i,1) = a_t_ave(i,1) + this->t2_meam[eltj] * rhoa0j; + a_t_ave(i,2) = a_t_ave(i,2) + this->t3_meam[eltj] * rhoa0j; + a_t_ave(j,0) = a_t_ave(j,0) + this->t1_meam[elti] * rhoa0i; + a_t_ave(j,1) = a_t_ave(j,1) + this->t2_meam[elti] * rhoa0i; + a_t_ave(j,2) = a_t_ave(j,2) + this->t3_meam[elti] * rhoa0i; + } + if (this->ialloy == 1) { + a_tsq_ave(i,0) = a_tsq_ave(i,0) + this->t1_meam[eltj] * this->t1_meam[eltj] * rhoa0j; + a_tsq_ave(i,1) = a_tsq_ave(i,1) + this->t2_meam[eltj] * this->t2_meam[eltj] * rhoa0j; + a_tsq_ave(i,2) = a_tsq_ave(i,2) + this->t3_meam[eltj] * this->t3_meam[eltj] * rhoa0j; + a_tsq_ave(j,0) = a_tsq_ave(j,0) + this->t1_meam[elti] * this->t1_meam[elti] * rhoa0i; + a_tsq_ave(j,1) = a_tsq_ave(j,1) + this->t2_meam[elti] * this->t2_meam[elti] * rhoa0i; + a_tsq_ave(j,2) = a_tsq_ave(j,2) + this->t3_meam[elti] * this->t3_meam[elti] * rhoa0i; + } + a_arho2b[i] += rhoa2j; + a_arho2b[j] += rhoa2i; + + A1j = rhoa1j / rij; + A2j = rhoa2j / rij2; + A3j = rhoa3j / (rij2 * rij); + A1i = rhoa1i / rij; + A2i = rhoa2i / rij2; + A3i = rhoa3i / (rij2 * rij); + nv2 = 0; + nv3 = 0; + for (m = 0; m < 3; m++) { + a_arho1(i,m) += A1j * delij[m]; + a_arho1(j,m) += (-A1i * delij[m]); + a_arho3b(i,m) += rhoa3j * delij[m] / rij; + a_arho3b(j,m) += (- rhoa3i * delij[m] / rij); + for (n = m; n < 3; n++) { + a_arho2(i,nv2) += A2j * delij[m] * delij[n]; + a_arho2(j,nv2) += A2i * delij[m] * delij[n]; + nv2 = nv2 + 1; + for (p = n; p < 3; p++) { + a_arho3(i,nv3) += A3j * delij[m] * delij[n] * delij[p]; + a_arho3(j,nv3) += (- A3i * delij[m] * delij[n] * delij[p]); + nv3 = nv3 + 1; + } + } + } + } + } + } +} + +//Cutoff function and derivative + +template +KOKKOS_INLINE_FUNCTION +double MEAMKokkos::dfcut(const double xi, double& dfc) const { + double a, a3, a4, a1m4; + if (xi >= 1.0) { + dfc = 0.0; + return 1.0; + } else if (xi <= 0.0) { + dfc = 0.0; + return 0.0; + } else { + a = 1.0 - xi; + a3 = a * a * a; + a4 = a * a3; + a1m4 = 1.0-a4; + + dfc = 8 * a1m4 * a3; + return a1m4*a1m4; + } + } + + //----------------------------------------------------------------------------- + // // Derivative of Cikj w.r.t. rij + // // Inputs: rij,rij2,rik2,rjk2 + // // + // + +template +KOKKOS_INLINE_FUNCTION +double MEAMKokkos::dCfunc(const double rij2, const double rik2, const double rjk2) const +{ + double rij4, a, asq, b,denom; + + rij4 = rij2 * rij2; + a = rik2 - rjk2; + b = rik2 + rjk2; + asq = a*a; + denom = rij4 - asq; + denom = denom * denom; + return -4 * (-2 * rij2 * asq + rij4 * b + asq * b) / denom; +} + +template +KOKKOS_INLINE_FUNCTION +void MEAMKokkos::dCfunc2(const double rij2, const double rik2, const double rjk2, double& dCikj1, double& dCikj2) const +{ + double rij4, rik4, rjk4, a, denom; + + rij4 = rij2 * rij2; + rik4 = rik2 * rik2; + rjk4 = rjk2 * rjk2; + a = rik2 - rjk2; + denom = rij4 - a * a; + denom = denom * denom; + dCikj1 = 4 * rij2 * (rij4 + rik4 + 2 * rik2 * rjk2 - 3 * rjk4 - 2 * rij2 * a) / denom; + dCikj2 = 4 * rij2 * (rij4 - 3 * rik4 + 2 * rik2 * rjk2 + rjk4 + 2 * rij2 * a) / denom; + +} +template +KOKKOS_INLINE_FUNCTION +double MEAMKokkos::fcut(const double xi) const{ + double a; + if (xi >= 1.0) + return 1.0; + else if (xi <= 0.0) + return 0.0; + else { + a = 1.0 - xi; + a *= a; a *= a; + a = 1.0 - a; + return a * a; + } + } + diff --git a/src/KOKKOS/meam_force_kokkos.h b/src/KOKKOS/meam_force_kokkos.h new file mode 100644 index 0000000000..4e061c9043 --- /dev/null +++ b/src/KOKKOS/meam_force_kokkos.h @@ -0,0 +1,554 @@ +#include "meam_kokkos.h" +#include "math_special_kokkos.h" +#include + +using namespace LAMMPS_NS; +using namespace MathSpecialKokkos; + + +template +void +MEAMKokkos::meam_force(int inum_half, int eflag_either, int eflag_global, int eflag_atom, int vflag_atom, double* eng_vdwl, + typename ArrayTypes::t_efloat_1d eatom, int ntype, typename AT::t_int_1d_randomread type, typename AT::t_int_1d_randomread fmap, typename AT::t_x_array_randomread x, typename AT::t_int_1d_randomread numneigh, + typename AT::t_int_1d_randomread numneigh_full, typename AT::t_f_array f, typename ArrayTypes::t_virial_array vatom, typename AT::t_int_1d_randomread d_ilist_half, typename AT::t_int_1d_randomread d_offset, typename AT::t_neighbors_2d d_neighbors_half, typename AT::t_neighbors_2d d_neighbors_full, int neighflag) +{ + EV_FLOAT ev; + ev.evdwl = *eng_vdwl; + + this->eflag_either = eflag_either; + this->eflag_global = eflag_global; + this->eflag_atom = eflag_atom; + this->vflag_atom = vflag_atom; + this->d_eatom = eatom; + this->ntype = ntype; + this->type = type; + this->fmap = fmap; + this->x = x; + this->d_numneigh_half = numneigh; + this->d_numneigh_full = numneigh_full; + this->d_neighbors_half = d_neighbors_half; + this->d_neighbors_full = d_neighbors_full; + this->f = f; + this->d_vatom = vatom; + this->d_ilist_half = d_ilist_half; + this->d_offset = d_offset; + + if (neighflag == FULL) + Kokkos::parallel_reduce(Kokkos::RangePolicy>(0,inum_half),*this,ev); + else if (neighflag == HALF) + Kokkos::parallel_reduce(Kokkos::RangePolicy>(0,inum_half),*this,ev); + else if (neighflag == HALFTHREAD) + Kokkos::parallel_reduce(Kokkos::RangePolicy>(0,inum_half),*this,ev); + *eng_vdwl = ev.evdwl; +} + +template +template +KOKKOS_INLINE_FUNCTION +void +MEAMKokkos::operator()(TagMEAMforce, const int &ii, EV_FLOAT& ev) const { + int i, j, jn, k, kn, kk, m, n, p, q; + int nv2, nv3, elti, eltj, eltk, ind; + X_FLOAT xitmp, yitmp, zitmp, delij[3]; + F_FLOAT rij2, rij, rij3; + F_FLOAT v[6], fi[3], fj[3]; + F_FLOAT third, sixth; + F_FLOAT pp, dUdrij, dUdsij, dUdrijm[3], force, forcem; + F_FLOAT r, recip, phi, phip; + F_FLOAT sij; + F_FLOAT a1, a1i, a1j, a2, a2i, a2j; + F_FLOAT a3i, a3j; + F_FLOAT shpi[3], shpj[3]; + F_FLOAT ai, aj, ro0i, ro0j, invrei, invrej; + F_FLOAT rhoa0j, drhoa0j, rhoa0i, drhoa0i; + F_FLOAT rhoa1j, drhoa1j, rhoa1i, drhoa1i; + F_FLOAT rhoa2j, drhoa2j, rhoa2i, drhoa2i; + F_FLOAT a3, a3a, rhoa3j, drhoa3j, rhoa3i, drhoa3i; + F_FLOAT drho0dr1, drho0dr2, drho0ds1, drho0ds2; + F_FLOAT drho1dr1, drho1dr2, drho1ds1, drho1ds2; + F_FLOAT drho1drm1[3], drho1drm2[3]; + F_FLOAT drho2dr1, drho2dr2, drho2ds1, drho2ds2; + F_FLOAT drho2drm1[3], drho2drm2[3]; + F_FLOAT drho3dr1, drho3dr2, drho3ds1, drho3ds2; + F_FLOAT drho3drm1[3], drho3drm2[3]; + F_FLOAT dt1dr1, dt1dr2, dt1ds1, dt1ds2; + F_FLOAT dt2dr1, dt2dr2, dt2ds1, dt2ds2; + F_FLOAT dt3dr1, dt3dr2, dt3ds1, dt3ds2; + F_FLOAT drhodr1, drhodr2, drhods1, drhods2, drhodrm1[3], drhodrm2[3]; + F_FLOAT arg; + F_FLOAT arg1i1, arg1j1, arg1i2, arg1j2, arg1i3, arg1j3, arg3i3, arg3j3; + F_FLOAT dsij1, dsij2, force1, force2; + F_FLOAT t1i, t2i, t3i, t1j, t2j, t3j; + int fnoffset; + + // To do: update with duplication for OpenMP, atomic for GPUs + Kokkos::View::value> > a_eatom = d_eatom; + Kokkos::View::value> > a_vatom = d_vatom; + Kokkos::View::value> > a_f = f; + + + i = d_ilist_half[ii]; + fnoffset = d_offset[i]; + third = 1.0 / 3.0; + sixth = 1.0 / 6.0; + // Compute forces atom i + + elti = fmap[type[i]]; + if (elti < 0) return; + + xitmp = x(i,0); + yitmp = x(i,1); + zitmp = x(i,2); + + // Treat each pair + for (jn = 0; jn < d_numneigh_half[i]; jn++) { + //j = firstneigh[jn]; + j = d_neighbors_half(i,jn); + eltj = fmap[type[j]]; + + if (!iszero_kk(d_scrfcn[fnoffset + jn]) && eltj >= 0) { + + sij = d_scrfcn[fnoffset + jn] * d_fcpair[fnoffset + jn]; + delij[0] = x(j,0) - xitmp; + delij[1] = x(j,1) - yitmp; + delij[2] = x(j,2) - zitmp; + rij2 = delij[0] * delij[0] + delij[1] * delij[1] + delij[2] * delij[2]; + if (rij2 < this->cutforcesq) { + rij = sqrt(rij2); + r = rij; + + // Compute phi and phip + ind = this->eltind[elti][eltj]; + pp = rij * this->rdrar; + kk = (int)pp; + kk = (kk <= (this->nrar - 2))?kk:this->nrar - 2; + pp = pp - kk; + pp = (pp <= 1.0)?pp:1.0; + phi = ((this->d_phirar3(ind,kk) * pp + this->d_phirar2(ind,kk)) * pp + this->d_phirar1(ind,kk)) * pp + + this->d_phirar(ind,kk); + phip = (this->d_phirar6(ind,kk) * pp + this->d_phirar5(ind,kk)) * pp + this->d_phirar4(ind,kk); + recip = 1.0 / r; + + if (eflag_either != 0) { + if (eflag_global != 0) + //*eng_vdwl = *eng_vdwl + phi * sij; + ev.evdwl = ev.evdwl + phi * sij; + if (eflag_atom != 0) { + a_eatom[i] += (0.5 * phi * sij); + a_eatom[j] += (0.5 * phi * sij); + } + } + + // write(1,*) "force_meamf: phi: ",phi + // write(1,*) "force_meamf: phip: ",phip + + // Compute pair densities and derivatives + invrei = 1.0 / this->re_meam[elti][elti]; + ai = rij * invrei - 1.0; + ro0i = this->rho0_meam[elti]; + rhoa0i = ro0i * MathSpecialKokkos::fm_exp(-this->beta0_meam[elti] * ai); + drhoa0i = -this->beta0_meam[elti] * invrei * rhoa0i; + rhoa1i = ro0i * MathSpecialKokkos::fm_exp(-this->beta1_meam[elti] * ai); + drhoa1i = -this->beta1_meam[elti] * invrei * rhoa1i; + rhoa2i = ro0i * MathSpecialKokkos::fm_exp(-this->beta2_meam[elti] * ai); + drhoa2i = -this->beta2_meam[elti] * invrei * rhoa2i; + rhoa3i = ro0i * MathSpecialKokkos::fm_exp(-this->beta3_meam[elti] * ai); + drhoa3i = -this->beta3_meam[elti] * invrei * rhoa3i; + + if (elti != eltj) { + invrej = 1.0 / this->re_meam[eltj][eltj]; + aj = rij * invrej - 1.0; + ro0j = this->rho0_meam[eltj]; + rhoa0j = ro0j * MathSpecialKokkos::fm_exp(-this->beta0_meam[eltj] * aj); + drhoa0j = -this->beta0_meam[eltj] * invrej * rhoa0j; + rhoa1j = ro0j * MathSpecialKokkos::fm_exp(-this->beta1_meam[eltj] * aj); + drhoa1j = -this->beta1_meam[eltj] * invrej * rhoa1j; + rhoa2j = ro0j * MathSpecialKokkos::fm_exp(-this->beta2_meam[eltj] * aj); + drhoa2j = -this->beta2_meam[eltj] * invrej * rhoa2j; + rhoa3j = ro0j * MathSpecialKokkos::fm_exp(-this->beta3_meam[eltj] * aj); + drhoa3j = -this->beta3_meam[eltj] * invrej * rhoa3j; + } else { + rhoa0j = rhoa0i; + drhoa0j = drhoa0i; + rhoa1j = rhoa1i; + drhoa1j = drhoa1i; + rhoa2j = rhoa2i; + drhoa2j = drhoa2i; + rhoa3j = rhoa3i; + drhoa3j = drhoa3i; + } + + const double t1mi = this->t1_meam[elti]; + const double t2mi = this->t2_meam[elti]; + const double t3mi = this->t3_meam[elti]; + const double t1mj = this->t1_meam[eltj]; + const double t2mj = this->t2_meam[eltj]; + const double t3mj = this->t3_meam[eltj]; + + if (this->ialloy == 1) { + rhoa1j *= t1mj; + rhoa2j *= t2mj; + rhoa3j *= t3mj; + rhoa1i *= t1mi; + rhoa2i *= t2mi; + rhoa3i *= t3mi; + drhoa1j *= t1mj; + drhoa2j *= t2mj; + drhoa3j *= t3mj; + drhoa1i *= t1mi; + drhoa2i *= t2mi; + drhoa3i *= t3mi; + } + + nv2 = 0; + nv3 = 0; + arg1i1 = 0.0; + arg1j1 = 0.0; + arg1i2 = 0.0; + arg1j2 = 0.0; + arg1i3 = 0.0; + arg1j3 = 0.0; + arg3i3 = 0.0; + arg3j3 = 0.0; + for (n = 0; n < 3; n++) { + for (p = n; p < 3; p++) { + for (q = p; q < 3; q++) { + arg = delij[n] * delij[p] * delij[q] * this->v3D[nv3]; + arg1i3 = arg1i3 + d_arho3(i,nv3) * arg; + arg1j3 = arg1j3 - d_arho3(j,nv3) * arg; + nv3 = nv3 + 1; + } + arg = delij[n] * delij[p] * this->v2D[nv2]; + arg1i2 = arg1i2 + d_arho2(i,nv2) * arg; + arg1j2 = arg1j2 + d_arho2(j,nv2) * arg; + nv2 = nv2 + 1; + } + arg1i1 = arg1i1 + d_arho1(i,n) * delij[n]; + arg1j1 = arg1j1 - d_arho1(j,n) * delij[n]; + arg3i3 = arg3i3 + d_arho3b(i,n) * delij[n]; + arg3j3 = arg3j3 - d_arho3b(j,n) * delij[n]; + } + + // rho0 terms + drho0dr1 = drhoa0j * sij; + drho0dr2 = drhoa0i * sij; + + // rho1 terms + a1 = 2 * sij / rij; + drho1dr1 = a1 * (drhoa1j - rhoa1j / rij) * arg1i1; + drho1dr2 = a1 * (drhoa1i - rhoa1i / rij) * arg1j1; + a1 = 2.0 * sij / rij; + for (m = 0; m < 3; m++) { + drho1drm1[m] = a1 * rhoa1j * d_arho1(i,m); + drho1drm2[m] = -a1 * rhoa1i * d_arho1(j,m); + } + + // rho2 terms + a2 = 2 * sij / rij2; + drho2dr1 = a2 * (drhoa2j - 2 * rhoa2j / rij) * arg1i2 - 2.0 / 3.0 * d_arho2b[i] * drhoa2j * sij; + drho2dr2 = a2 * (drhoa2i - 2 * rhoa2i / rij) * arg1j2 - 2.0 / 3.0 * d_arho2b[j] * drhoa2i * sij; + a2 = 4 * sij / rij2; + for (m = 0; m < 3; m++) { + drho2drm1[m] = 0.0; + drho2drm2[m] = 0.0; + for (n = 0; n < 3; n++) { + drho2drm1[m] = drho2drm1[m] + d_arho2(i,this->vind2D[m][n]) * delij[n]; + drho2drm2[m] = drho2drm2[m] - d_arho2(j,this->vind2D[m][n]) * delij[n]; + } + drho2drm1[m] = a2 * rhoa2j * drho2drm1[m]; + drho2drm2[m] = -a2 * rhoa2i * drho2drm2[m]; + } + + // rho3 terms + rij3 = rij * rij2; + a3 = 2 * sij / rij3; + a3a = 6.0 / 5.0 * sij / rij; + drho3dr1 = a3 * (drhoa3j - 3 * rhoa3j / rij) * arg1i3 - a3a * (drhoa3j - rhoa3j / rij) * arg3i3; + drho3dr2 = a3 * (drhoa3i - 3 * rhoa3i / rij) * arg1j3 - a3a * (drhoa3i - rhoa3i / rij) * arg3j3; + a3 = 6 * sij / rij3; + a3a = 6 * sij / (5 * rij); + for (m = 0; m < 3; m++) { + drho3drm1[m] = 0.0; + drho3drm2[m] = 0.0; + nv2 = 0; + for (n = 0; n < 3; n++) { + for (p = n; p < 3; p++) { + arg = delij[n] * delij[p] * this->v2D[nv2]; + drho3drm1[m] = drho3drm1[m] + d_arho3(i,this->vind3D[m][n][p]) * arg; + drho3drm2[m] = drho3drm2[m] + d_arho3(j,this->vind3D[m][n][p]) * arg; + nv2 = nv2 + 1; + } + } + drho3drm1[m] = (a3 * drho3drm1[m] - a3a * d_arho3b(i,m)) * rhoa3j; + drho3drm2[m] = (-a3 * drho3drm2[m] + a3a * d_arho3b(j,m)) * rhoa3i; + } + + // Compute derivatives of weighting functions t wrt rij + t1i = d_t_ave(i,0); + t2i = d_t_ave(i,1); + t3i = d_t_ave(i,2); + t1j = d_t_ave(j,0); + t2j = d_t_ave(j,1); + t3j = d_t_ave(j,2); + + if (this->ialloy == 1) { + + a1i = fdiv_zero_kk(drhoa0j * sij, d_tsq_ave(i,0)); + a1j = fdiv_zero_kk(drhoa0i * sij, d_tsq_ave(j,0)); + a2i = fdiv_zero_kk(drhoa0j * sij, d_tsq_ave(i,1)); + a2j = fdiv_zero_kk(drhoa0i * sij, d_tsq_ave(j,1)); + a3i = fdiv_zero_kk(drhoa0j * sij, d_tsq_ave(i,2)); + a3j = fdiv_zero_kk(drhoa0i * sij, d_tsq_ave(j,2)); + + dt1dr1 = a1i * (t1mj - t1i * MathSpecialKokkos::square(t1mj)); + dt1dr2 = a1j * (t1mi - t1j * MathSpecialKokkos::square(t1mi)); + dt2dr1 = a2i * (t2mj - t2i * MathSpecialKokkos::square(t2mj)); + dt2dr2 = a2j * (t2mi - t2j * MathSpecialKokkos::square(t2mi)); + dt3dr1 = a3i * (t3mj - t3i * MathSpecialKokkos::square(t3mj)); + dt3dr2 = a3j * (t3mi - t3j * MathSpecialKokkos::square(t3mi)); + + } else if (this->ialloy == 2) { + + dt1dr1 = 0.0; + dt1dr2 = 0.0; + dt2dr1 = 0.0; + dt2dr2 = 0.0; + dt3dr1 = 0.0; + dt3dr2 = 0.0; + + } else { + + ai = 0.0; + if (!iszero_kk(d_rho0[i])) + ai = drhoa0j * sij / d_rho0[i]; + aj = 0.0; + if (!iszero_kk(d_rho0[j])) + aj = drhoa0i * sij / d_rho0[j]; + + dt1dr1 = ai * (t1mj - t1i); + dt1dr2 = aj * (t1mi - t1j); + dt2dr1 = ai * (t2mj - t2i); + dt2dr2 = aj * (t2mi - t2j); + dt3dr1 = ai * (t3mj - t3i); + dt3dr2 = aj * (t3mi - t3j); + } + + // Compute derivatives of total density wrt rij, sij and rij(3) + get_shpfcn(this->lattce_meam[elti][elti], shpi); + get_shpfcn(this->lattce_meam[eltj][eltj], shpj); + drhodr1 = dgamma1[i] * drho0dr1 + + dgamma2[i] * (dt1dr1 * d_rho1[i] + t1i * drho1dr1 + dt2dr1 * d_rho2[i] + t2i * drho2dr1 + + dt3dr1 * d_rho3[i] + t3i * drho3dr1) - + dgamma3[i] * (shpi[0] * dt1dr1 + shpi[1] * dt2dr1 + shpi[2] * dt3dr1); + drhodr2 = dgamma1[j] * drho0dr2 + + dgamma2[j] * (dt1dr2 * d_rho1[j] + t1j * drho1dr2 + dt2dr2 * d_rho2[j] + t2j * drho2dr2 + + dt3dr2 * d_rho3[j] + t3j * drho3dr2) - + dgamma3[j] * (shpj[0] * dt1dr2 + shpj[1] * dt2dr2 + shpj[2] * dt3dr2); + for (m = 0; m < 3; m++) { + drhodrm1[m] = 0.0; + drhodrm2[m] = 0.0; + drhodrm1[m] = dgamma2[i] * (t1i * drho1drm1[m] + t2i * drho2drm1[m] + t3i * drho3drm1[m]); + drhodrm2[m] = dgamma2[j] * (t1j * drho1drm2[m] + t2j * drho2drm2[m] + t3j * drho3drm2[m]); + } + + // Compute derivatives wrt sij, but only if necessary + if (!iszero_kk(d_dscrfcn[fnoffset + jn])) { + drho0ds1 = rhoa0j; + drho0ds2 = rhoa0i; + a1 = 2.0 / rij; + drho1ds1 = a1 * rhoa1j * arg1i1; + drho1ds2 = a1 * rhoa1i * arg1j1; + a2 = 2.0 / rij2; + drho2ds1 = a2 * rhoa2j * arg1i2 - 2.0 / 3.0 * d_arho2b[i] * rhoa2j; + drho2ds2 = a2 * rhoa2i * arg1j2 - 2.0 / 3.0 * d_arho2b[j] * rhoa2i; + a3 = 2.0 / rij3; + a3a = 6.0 / (5.0 * rij); + drho3ds1 = a3 * rhoa3j * arg1i3 - a3a * rhoa3j * arg3i3; + drho3ds2 = a3 * rhoa3i * arg1j3 - a3a * rhoa3i * arg3j3; + + if (this->ialloy == 1) { + a1i = fdiv_zero_kk(rhoa0j, d_tsq_ave(i,0)); + a1j = fdiv_zero_kk(rhoa0i, d_tsq_ave(j,0)); + a2i = fdiv_zero_kk(rhoa0j, d_tsq_ave(i,1)); + a2j = fdiv_zero_kk(rhoa0i, d_tsq_ave(j,1)); + a3i = fdiv_zero_kk(rhoa0j, d_tsq_ave(i,2)); + a3j = fdiv_zero_kk(rhoa0i, d_tsq_ave(j,2)); + + dt1ds1 = a1i * (t1mj - t1i * MathSpecialKokkos::square(t1mj)); + dt1ds2 = a1j * (t1mi - t1j * MathSpecialKokkos::square(t1mi)); + dt2ds1 = a2i * (t2mj - t2i * MathSpecialKokkos::square(t2mj)); + dt2ds2 = a2j * (t2mi - t2j * MathSpecialKokkos::square(t2mi)); + dt3ds1 = a3i * (t3mj - t3i * MathSpecialKokkos::square(t3mj)); + dt3ds2 = a3j * (t3mi - t3j * MathSpecialKokkos::square(t3mi)); + + } else if (this->ialloy == 2) { + + dt1ds1 = 0.0; + dt1ds2 = 0.0; + dt2ds1 = 0.0; + dt2ds2 = 0.0; + dt3ds1 = 0.0; + dt3ds2 = 0.0; + + } else { + + ai = 0.0; + if (!iszero_kk(d_rho0[i])) + ai = rhoa0j / d_rho0[i]; + aj = 0.0; + if (!iszero_kk(d_rho0[j])) + aj = rhoa0i / d_rho0[j]; + + dt1ds1 = ai * (t1mj - t1i); + dt1ds2 = aj * (t1mi - t1j); + dt2ds1 = ai * (t2mj - t2i); + dt2ds2 = aj * (t2mi - t2j); + dt3ds1 = ai * (t3mj - t3i); + dt3ds2 = aj * (t3mi - t3j); + } + + drhods1 = d_dgamma1[i] * drho0ds1 + + d_dgamma2[i] * (dt1ds1 * d_rho1[i] + t1i * drho1ds1 + dt2ds1 * d_rho2[i] + t2i * drho2ds1 + + dt3ds1 * d_rho3[i] + t3i * drho3ds1) - + d_dgamma3[i] * (shpi[0] * dt1ds1 + shpi[1] * dt2ds1 + shpi[2] * dt3ds1); + drhods2 = d_dgamma1[j] * drho0ds2 + + d_dgamma2[j] * (dt1ds2 * d_rho1[j] + t1j * drho1ds2 + dt2ds2 * d_rho2[j] + t2j * drho2ds2 + + dt3ds2 * d_rho3[j] + t3j * drho3ds2) - + d_dgamma3[j] * (shpj[0] * dt1ds2 + shpj[1] * dt2ds2 + shpj[2] * dt3ds2); + } + + // Compute derivatives of energy wrt rij, sij and rij[3] + dUdrij = phip * sij + d_frhop[i] * drhodr1 + d_frhop[j] * drhodr2; + dUdsij = 0.0; + if (!iszero_kk(d_dscrfcn[fnoffset + jn])) { + dUdsij = phi + d_frhop[i] * drhods1 + d_frhop[j] * drhods2; + } + for (m = 0; m < 3; m++) { + dUdrijm[m] = d_frhop[i] * drhodrm1[m] + d_frhop[j] * drhodrm2[m]; + } + + // Add the part of the force due to dUdrij and dUdsij + force = dUdrij * recip + dUdsij * d_dscrfcn[fnoffset + jn]; + for (m = 0; m < 3; m++) { + forcem = delij[m] * force + dUdrijm[m]; + a_f(i,m) += forcem; + a_f(j,m) -= -forcem; + } + + // Tabulate per-atom virial as symmetrized stress tensor + + if (vflag_atom != 0) { + fi[0] = delij[0] * force + dUdrijm[0]; + fi[1] = delij[1] * force + dUdrijm[1]; + fi[2] = delij[2] * force + dUdrijm[2]; + v[0] = -0.5 * (delij[0] * fi[0]); + v[1] = -0.5 * (delij[1] * fi[1]); + v[2] = -0.5 * (delij[2] * fi[2]); + v[3] = -0.25 * (delij[0] * fi[1] + delij[1] * fi[0]); + v[4] = -0.25 * (delij[0] * fi[2] + delij[2] * fi[0]); + v[5] = -0.25 * (delij[1] * fi[2] + delij[2] * fi[1]); + + for (m = 0; m < 6; m++) { + a_vatom(i,m) += v[m]; + a_vatom(j,m) += v[m]; + } + } + + // Now compute forces on other atoms k due to change in sij + + if (iszero_kk(sij) || iszero_kk(sij - 1.0)) continue; //: cont jn loop + + double dxik(0), dyik(0), dzik(0); + double dxjk(0), dyjk(0), dzjk(0); + + for (kn = 0; kn < d_numneigh_full[i]; kn++) { + //k = firstneigh_full[kn]; + k = d_neighbors_full(i,kn); + eltk = fmap[type[k]]; + if (k != j && eltk >= 0) { + double xik, xjk, cikj, sikj, dfc, a; + double dCikj1, dCikj2; + double delc, rik2, rjk2; + + sij = d_scrfcn[jn+fnoffset] * d_fcpair[jn+fnoffset]; + const double Cmax = this->Cmax_meam[elti][eltj][eltk]; + const double Cmin = this->Cmin_meam[elti][eltj][eltk]; + + dsij1 = 0.0; + dsij2 = 0.0; + if (!iszero_kk(sij) && !iszero_kk(sij - 1.0)) { + const double rbound = rij2 * this->ebound_meam[elti][eltj]; + delc = Cmax - Cmin; + dxjk = x(k,0) - x(j,0); + dyjk = x(k,1) - x(j,1); + dzjk = x(k,2) - x(j,2); + rjk2 = dxjk * dxjk + dyjk * dyjk + dzjk * dzjk; + if (rjk2 <= rbound) { + dxik = x(k,0) - x(i,0); + dyik = x(k,1) - x(i,1); + dzik = x(k,2) - x(i,2); + rik2 = dxik * dxik + dyik * dyik + dzik * dzik; + if (rik2 <= rbound) { + xik = rik2 / rij2; + xjk = rjk2 / rij2; + a = 1 - (xik - xjk) * (xik - xjk); + if (!iszero_kk(a)) { + cikj = (2.0 * (xik + xjk) + a - 2.0) / a; + if (cikj >= Cmin && cikj <= Cmax) { + cikj = (cikj - Cmin) / delc; + sikj = dfcut(cikj, dfc); + dCfunc2(rij2, rik2, rjk2, dCikj1, dCikj2); + a = sij / delc * dfc / sikj; + dsij1 = a * dCikj1; + dsij2 = a * dCikj2; + } + } + } + } + } + + if (!iszero_kk(dsij1) || !iszero_kk(dsij2)) { + force1 = dUdsij * dsij1; + force2 = dUdsij * dsij2; + + a_f(i,0) += force1 * dxik; + a_f(i,1) += force1 * dyik; + a_f(i,2) += force1 * dzik; + a_f(j,0) += force2 * dxjk; + a_f(j,1) += force2 * dyjk; + a_f(j,2) += force2 * dzjk; + a_f(k,0) -= force1 * dxik + force2 * dxjk; + a_f(k,1) -= force1 * dyik + force2 * dyjk; + a_f(k,2) -= force1 * dzik + force2 * dzjk; + + // Tabulate per-atom virial as symmetrized stress tensor + + if (vflag_atom != 0) { + fi[0] = force1 * dxik; + fi[1] = force1 * dyik; + fi[2] = force1 * dzik; + fj[0] = force2 * dxjk; + fj[1] = force2 * dyjk; + fj[2] = force2 * dzjk; + v[0] = -third * (dxik * fi[0] + dxjk * fj[0]); + v[1] = -third * (dyik * fi[1] + dyjk * fj[1]); + v[2] = -third * (dzik * fi[2] + dzjk * fj[2]); + v[3] = -sixth * (dxik * fi[1] + dxjk * fj[1] + dyik * fi[0] + dyjk * fj[0]); + v[4] = -sixth * (dxik * fi[2] + dxjk * fj[2] + dzik * fi[0] + dzjk * fj[0]); + v[5] = -sixth * (dyik * fi[2] + dyjk * fj[2] + dzik * fi[1] + dzjk * fj[1]); + + for (m = 0; m < 6; m++) { + a_vatom(i,m) += v[m]; + a_vatom(j,m) += v[m]; + a_vatom(k,m) += v[m]; + } + } + } + } + // end of k loop + } + } + } + // end of j loop + } +} diff --git a/src/KOKKOS/meam_funcs_kokkos.h b/src/KOKKOS/meam_funcs_kokkos.h new file mode 100644 index 0000000000..9e41be9ea8 --- /dev/null +++ b/src/KOKKOS/meam_funcs_kokkos.h @@ -0,0 +1,326 @@ +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +/* ---------------------------------------------------------------------- + Contributing author: Sebastian Hütter (OvGU) +------------------------------------------------------------------------- */ + +#include "math_special_kokkos.h" +#include +#include "meam_kokkos.h" +using namespace MathSpecialKokkos; + +//----------------------------------------------------------------------------- +// Compute G(gamma) based on selection flag ibar: +// 0 => G = sqrt(1+gamma) +// 1 => G = exp(gamma/2) +// 2 => not implemented +// 3 => G = 2/(1+exp(-gamma)) +// 4 => G = sqrt(1+gamma) +// -5 => G = +-sqrt(abs(1+gamma)) +// +template +KOKKOS_INLINE_FUNCTION +double MEAMKokkos::G_gam(const double gamma, const int ibar, int &errorflag) const +{ + double gsmooth_switchpoint; + + switch (ibar) { + case 0: + case 4: + gsmooth_switchpoint = -gsmooth_factor / (gsmooth_factor + 1); + if (gamma < gsmooth_switchpoint) { + // e.g. gsmooth_factor is 99, {: + // gsmooth_switchpoint = -0.99 + // G = 0.01*(-0.99/gamma)**99 + double G = 1 / (gsmooth_factor + 1) * pow((gsmooth_switchpoint / gamma), gsmooth_factor); + return sqrt(G); + } else { + return sqrt(1.0 + gamma); + } + case 1: + return MathSpecialKokkos::fm_exp(gamma / 2.0); + case 3: + return 2.0 / (1.0 + exp(-gamma)); + case -5: + if ((1.0 + gamma) >= 0) { + return sqrt(1.0 + gamma); + } else { + return -sqrt(-1.0 - gamma); + } + } + errorflag = 1; + return 0.0; +} + +//----------------------------------------------------------------------------- +// Compute G(gamma and dG(gamma) based on selection flag ibar: +// 0 => G = sqrt(1+gamma) +// 1 => G = exp(gamma/2) +// 2 => not implemented +// 3 => G = 2/(1+exp(-gamma)) +// 4 => G = sqrt(1+gamma) +// -5 => G = +-sqrt(abs(1+gamma)) +// +template +KOKKOS_INLINE_FUNCTION +double MEAMKokkos::dG_gam(const double gamma, const int ibar, double& dG) const +{ + double gsmooth_switchpoint; + double G; + + switch (ibar) { + case 0: + case 4: + gsmooth_switchpoint = -gsmooth_factor / (gsmooth_factor + 1); + if (gamma < gsmooth_switchpoint) { + // e.g. gsmooth_factor is 99, {: + // gsmooth_switchpoint = -0.99 + // G = 0.01*(-0.99/gamma)**99 + G = 1 / (gsmooth_factor + 1) * pow((gsmooth_switchpoint / gamma), gsmooth_factor); + G = sqrt(G); + dG = -gsmooth_factor * G / (2.0 * gamma); + return G; + } else { + G = sqrt(1.0 + gamma); + dG = 1.0 / (2.0 * G); + return G; + } + case 1: + G = MathSpecialKokkos::fm_exp(gamma / 2.0); + dG = G / 2.0; + return G; + case 3: + G = 2.0 / (1.0 + MathSpecialKokkos::fm_exp(-gamma)); + dG = G * (2.0 - G) / 2; + return G; + case -5: + if ((1.0 + gamma) >= 0) { + G = sqrt(1.0 + gamma); + dG = 1.0 / (2.0 * G); + return G; + } else { + G = -sqrt(-1.0 - gamma); + dG = -1.0 / (2.0 * G); + return G; + } + } + dG = 1.0; + return 0.0; +} + +//----------------------------------------------------------------------------- +// Compute ZBL potential +// +template +KOKKOS_INLINE_FUNCTION +double MEAMKokkos::zbl(const double r, const int z1, const int z2) const +{ + int i; + const double c[] = { 0.028171, 0.28022, 0.50986, 0.18175 }; + const double d[] = { 0.20162, 0.40290, 0.94229, 3.1998 }; + const double azero = 0.4685; + const double cc = 14.3997; + double a, x; + // azero = (9pi^2/128)^1/3 (0.529) Angstroms + a = azero / (pow(z1, 0.23) + pow(z2, 0.23)); + double result = 0.0; + x = r / a; + for (i = 0; i <= 3; i++) { + result = result + c[i] * MathSpecialKokkos::fm_exp(-d[i] * x); + } + if (r > 0.0) + result = result * z1 * z2 / r * cc; + return result; +} + +//----------------------------------------------------------------------------- +// Compute Rose energy function, I.16 +// +template +KOKKOS_INLINE_FUNCTION +double MEAMKokkos::erose(const double r, const double re, const double alpha, const double Ec, const double repuls, + const double attrac, const int form) const +{ + double astar, a3; + double result = 0.0; + + if (r > 0.0) { + astar = alpha * (r / re - 1.0); + a3 = 0.0; + if (astar >= 0) + a3 = attrac; + else if (astar < 0) + a3 = repuls; + + if (form == 1) + result = -Ec * (1 + astar + (-attrac + repuls / r) * MathSpecialKokkos::cube(astar)) * MathSpecialKokkos::fm_exp(-astar); + else if (form == 2) + result = -Ec * (1 + astar + a3 * MathSpecialKokkos::cube(astar)) * MathSpecialKokkos::fm_exp(-astar); + else + result = -Ec * (1 + astar + a3 * MathSpecialKokkos::cube(astar) / (r / re)) * MathSpecialKokkos::fm_exp(-astar); + } + return result; +} + +//----------------------------------------------------------------------------- +// Shape factors for various configurations +// +template +KOKKOS_INLINE_FUNCTION +void MEAMKokkos::get_shpfcn(const lattice_t latt, double (&s)[3]) const +{ + switch (latt) { + case FCC: + case BCC: + case B1: + case B2: + s[0] = 0.0; + s[1] = 0.0; + s[2] = 0.0; + break; + case HCP: + s[0] = 0.0; + s[1] = 0.0; + s[2] = 1.0 / 3.0; + break; + case DIA: + s[0] = 0.0; + s[1] = 0.0; + s[2] = 32.0 / 9.0; + break; + case DIM: + s[0] = 1.0; + s[1] = 2.0 / 3.0; + // s(3) = 1.d0 + s[2] = 0.40; + break; + default: + s[0] = 0.0; + // call error('Lattice not defined in get_shpfcn.') + } +} + +//----------------------------------------------------------------------------- +// Number of neighbors for the reference structure +// +template +KOKKOS_INLINE_FUNCTION +int MEAMKokkos::get_Zij(const lattice_t latt) const +{ + switch (latt) { + case FCC: + return 12; + case BCC: + return 8; + case HCP: + return 12; + case B1: + return 6; + case DIA: + return 4; + case DIM: + return 1; + case C11: + return 10; + case L12: + return 12; + case B2: + return 8; + // call error('Lattice not defined in get_Zij.') + } + return 0; +} + +//----------------------------------------------------------------------------- +// Number of second neighbors for the reference structure +// a = distance ratio R1/R2 +// S = second neighbor screening function +// +template +KOKKOS_INLINE_FUNCTION +int MEAMKokkos::get_Zij2(const lattice_t latt, const double cmin, const double cmax, double& a, double& S) const +{ + + double C, x, sijk; + int Zij2 = 0, numscr = 0; + + switch (latt) { + + case FCC: + Zij2 = 6; + a = sqrt(2.0); + numscr = 4; + break; + + case BCC: + Zij2 = 6; + a = 2.0 / sqrt(3.0); + numscr = 4; + break; + + case HCP: + Zij2 = 6; + a = sqrt(2.0); + numscr = 4; + break; + + case B1: + Zij2 = 12; + a = sqrt(2.0); + numscr = 2; + break; + + case DIA: + Zij2 = 12; + a = sqrt(8.0 / 3.0); + numscr = 1; + if (cmin < 0.500001) { + // call error('can not do 2NN MEAM for dia') + } + break; + + case DIM: + // this really shouldn't be allowed; make sure screening is zero + a = 1.0; + S = 0.0; + return 0; + + case L12: + Zij2 = 6; + a = sqrt(2.0); + numscr = 4; + break; + + case B2: + Zij2 = 6; + a = 2.0 / sqrt(3.0); + numscr = 4; + break; + case C11: + // unsupported lattice flag C11 in get_Zij + break; + default: + // unknown lattic flag in get Zij + // call error('Lattice not defined in get_Zij.') + break; + } + + // Compute screening for each first neighbor + C = 4.0 / (a * a) - 1.0; + x = (C - cmin) / (cmax - cmin); + sijk = fcut(x); + // There are numscr first neighbors screening the second neighbors + S = MathSpecialKokkos::powint(sijk, numscr); + return Zij2; +} diff --git a/src/KOKKOS/meam_impl_kokkos.h b/src/KOKKOS/meam_impl_kokkos.h new file mode 100644 index 0000000000..0d2ec99445 --- /dev/null +++ b/src/KOKKOS/meam_impl_kokkos.h @@ -0,0 +1,72 @@ +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +/* ---------------------------------------------------------------------- + Contributing author: Sebastian Hütter (OvGU) +------------------------------------------------------------------------- */ + +#include "memory_kokkos.h" +#include "meam_kokkos.h" +using namespace LAMMPS_NS; + +/* ---------------------------------------------------------------------- */ + +template +MEAMKokkos::MEAMKokkos(Memory *mem) : MEAM(mem) +{ +} + +template +MEAMKokkos::~MEAMKokkos() +{ + MemoryKokkos *memoryKK = (MemoryKokkos *)memory; + + memoryKK->destroy_kokkos(k_phirar6,phirar6); + memoryKK->destroy_kokkos(k_phirar5,phirar5); + memoryKK->destroy_kokkos(k_phirar4,phirar4); + memoryKK->destroy_kokkos(k_phirar3,phirar3); + memoryKK->destroy_kokkos(k_phirar2,phirar2); + memoryKK->destroy_kokkos(k_phirar1,phirar1); + memoryKK->destroy_kokkos(k_phirar,phirar); + memoryKK->destroy_kokkos(k_phir,phir); + + memoryKK->destroy_kokkos(k_rho,rho); + memoryKK->destroy_kokkos(k_rho0,rho0); + memoryKK->destroy_kokkos(k_rho1,rho1); + memoryKK->destroy_kokkos(k_rho2,rho2); + memoryKK->destroy_kokkos(k_rho3,rho3); + memoryKK->destroy_kokkos(k_frhop,frhop); + memoryKK->destroy_kokkos(k_gamma,gamma); + memoryKK->destroy_kokkos(k_dgamma1,dgamma1); + memoryKK->destroy_kokkos(k_dgamma2,dgamma2); + memoryKK->destroy_kokkos(k_dgamma3,dgamma3); + memoryKK->destroy_kokkos(k_arho2b,arho2b); + + memoryKK->destroy_kokkos(k_arho1,arho1); + memoryKK->destroy_kokkos(k_arho2,arho2); + memoryKK->destroy_kokkos(k_arho3,arho3); + memoryKK->destroy_kokkos(k_arho3b,arho3b); + memoryKK->destroy_kokkos(k_t_ave,t_ave); + memoryKK->destroy_kokkos(k_tsq_ave,tsq_ave); + + memoryKK->destroy_kokkos(k_scrfcn,scrfcn); + memoryKK->destroy_kokkos(k_dscrfcn,dscrfcn); + memoryKK->destroy_kokkos(k_fcpair,fcpair); +} +#include "meam_setup_done_kokkos.h" +#include "meam_funcs_kokkos.h" +#include "meam_dens_init_kokkos.h" +#include "meam_dens_final_kokkos.h" +#include "meam_force_kokkos.h" +// + diff --git a/src/KOKKOS/meam_kokkos.h b/src/KOKKOS/meam_kokkos.h new file mode 100644 index 0000000000..0231f4b767 --- /dev/null +++ b/src/KOKKOS/meam_kokkos.h @@ -0,0 +1,142 @@ +#ifndef LMP_MEAMKOKKOS_H +#define LMP_MEAMKOKKOS_H + +#include "meam.h" +#include "memory_kokkos.h" +#include "neigh_request.h" +#include "neighbor_kokkos.h" +#include "kokkos.h" +#include +#include + +namespace LAMMPS_NS { + +struct TagMEAMDensFinal{}; +template +struct TagMEAMDensInit{}; +struct TagMEAMInitialize{}; +template +struct TagMEAMforce{}; + +template +class MEAMKokkos : public MEAM +{ +public: + typedef ArrayTypes AT; + typedef EV_FLOAT value_type; + MEAMKokkos(Memory* mem); + ~MEAMKokkos(); + + KOKKOS_INLINE_FUNCTION + void operator()(TagMEAMDensFinal, const int&, EV_FLOAT&) const; + + template + KOKKOS_INLINE_FUNCTION + void operator()(TagMEAMDensInit, const int&, EV_FLOAT&) const; + + KOKKOS_INLINE_FUNCTION + void operator()(TagMEAMInitialize, const int&) const; + + template + KOKKOS_INLINE_FUNCTION + void operator()(TagMEAMforce, const int&, EV_FLOAT&) const; +protected: +//Parameters to meam_dens_init - is there a better way to do this? + int ntype; + typename AT::t_int_1d_randomread type; + typename AT::t_int_1d_randomread d_offset; + typename AT::t_int_1d_randomread fmap; + typename AT::t_x_array_randomread x; + typename AT::t_int_1d_randomread d_numneigh_half; + typename AT::t_int_1d_randomread d_numneigh_full; + typename AT::t_neighbors_2d d_neighbors_half; + typename AT::t_neighbors_2d d_neighbors_full; + typename AT::t_int_1d_randomread d_ilist_half; + typename AT::t_f_array f; + typename ArrayTypes::t_virial_array d_vatom; +//Parameters to meam_dens_final - is there a better way to do this? + int eflag_either, eflag_global, eflag_atom, vflag_atom; + double *eng_vdwl; + typename ArrayTypes::t_efloat_1d d_eatom; + +public: + void meam_dens_setup(int, int, int); + void meam_setup_done(void); + void meam_dens_init(int , int , typename AT::t_int_1d_randomread , typename AT::t_int_1d_randomread, typename AT::t_x_array_randomread, typename AT::t_int_1d_randomread, + typename AT::t_int_1d_randomread , int* , typename AT::t_int_1d_randomread, typename AT::t_neighbors_2d,typename AT::t_neighbors_2d,typename AT::t_int_1d_randomread, int ); + void meam_dens_final(int , int , int , int , double* , + typename ArrayTypes::t_efloat_1d , int , typename AT::t_int_1d_randomread , typename AT::t_int_1d_randomread , int& ); + void meam_force(int , int , int , int , int , double* , + typename ArrayTypes::t_efloat_1d , int , typename AT::t_int_1d_randomread , typename AT::t_int_1d_randomread , typename AT::t_x_array_randomread , typename AT::t_int_1d_randomread , + typename AT::t_int_1d_randomread , typename AT::t_f_array , typename ArrayTypes::t_virial_array ,typename AT::t_int_1d_randomread , typename AT::t_int_1d_randomread, typename AT::t_neighbors_2d, typename AT::t_neighbors_2d, int); + template + KOKKOS_INLINE_FUNCTION + void getscreen(int , int, typename AT::t_x_array_randomread , typename AT::t_int_1d_randomread, + typename AT::t_int_1d_randomread, int , typename AT::t_int_1d_randomread , typename AT::t_int_1d_randomread ) const; + template + KOKKOS_INLINE_FUNCTION + void calc_rho1(int , int , typename AT::t_int_1d_randomread , typename AT::t_int_1d_randomread , typename AT::t_x_array_randomread , typename AT::t_int_1d_randomread, int ) const; + KOKKOS_INLINE_FUNCTION + double fcut(const double xi) const; + KOKKOS_INLINE_FUNCTION + double dfcut(const double xi, double& dfc) const; + KOKKOS_INLINE_FUNCTION + double dCfunc(const double, const double, const double) const; + KOKKOS_INLINE_FUNCTION + void dCfunc2(const double, const double, const double, double&, double&) const; + KOKKOS_INLINE_FUNCTION + double G_gam(const double, const int, int&) const; + KOKKOS_INLINE_FUNCTION + double dG_gam(const double, const int, double&) const; + KOKKOS_INLINE_FUNCTION + double zbl(const double, const int, const int) const; + KOKKOS_INLINE_FUNCTION + double erose(const double, const double, const double, const double, const double, const double, const int) const; + KOKKOS_INLINE_FUNCTION + void get_shpfcn(const lattice_t latt, double (&s)[3]) const; + KOKKOS_INLINE_FUNCTION + int get_Zij(const lattice_t ) const; + KOKKOS_INLINE_FUNCTION + int get_Zij2(const lattice_t, const double, const double, double&, double&) const; +public: + DAT::tdual_ffloat_1d k_rho, k_rho0, k_rho1, k_rho2, k_rho3, k_frhop; + typename ArrayTypes::t_ffloat_1d d_rho, d_rho0,d_rho1, d_rho2, d_rho3, d_frhop; + HAT::t_ffloat_1d h_rho, h_rho0, h_rho1, h_rho2, h_rho3, h_frhop; + DAT::tdual_ffloat_1d k_gamma, k_dgamma1, k_dgamma2, k_dgamma3, k_arho2b; + typename ArrayTypes::t_ffloat_1d d_gamma, d_dgamma1, d_dgamma2, d_dgamma3, d_arho2b; + HAT::t_ffloat_1d h_gamma, h_dgamma1, h_dgamma2, h_dgamma3, h_arho2b; + DAT::tdual_ffloat_2d k_arho1, k_arho2, k_arho3, k_arho3b, k_t_ave, k_tsq_ave; + typename ArrayTypes::t_ffloat_2d d_arho1, d_arho2, d_arho3, d_arho3b, d_t_ave, d_tsq_ave; + HAT::t_ffloat_2d h_arho1, h_arho2, h_arho3, h_arho3b, h_t_ave, h_tsq_ave; + DAT::tdual_ffloat_2d k_phir, k_phirar, k_phirar1, k_phirar2, k_phirar3, k_phirar4, k_phirar5, k_phirar6; + typename ArrayTypes::t_ffloat_2d d_phir, d_phirar, d_phirar1, d_phirar2, d_phirar3, d_phirar4, d_phirar5, d_phirar6; + HAT::t_ffloat_2d h_phir, h_phirar, h_phirar1, h_phirar2, h_phirar3, h_phirar4, h_phirar5, h_phirar6; + DAT::tdual_ffloat_1d k_scrfcn, k_dscrfcn, k_fcpair; + typename ArrayTypes::t_ffloat_1d d_scrfcn, d_dscrfcn, d_fcpair; + HAT::t_ffloat_1d h_scrfcn, h_dscrfcn, h_fcpair; + + +}; +KOKKOS_INLINE_FUNCTION +static bool iszero_kk(const double f) { + return fabs(f) < 1e-20; +} + + +KOKKOS_INLINE_FUNCTION +static double fdiv_zero_kk(const double n, const double d) { + if (iszero_kk(d)) + return 0.0; + return n / d; +} + +// Functions we need for compat + +} +#include "meam_impl_kokkos.h" +//#include "meam_setup_done_kokkos.h" +//#include "meam_funcs_kokkos.h" +//#include "meam_dens_init_kokkos.h" +//#include "meam_dens_final_kokkos.h" +//#include "meam_force_kokkos.h" +#endif diff --git a/src/KOKKOS/meam_setup_done_kokkos.h b/src/KOKKOS/meam_setup_done_kokkos.h new file mode 100644 index 0000000000..72852bf2cb --- /dev/null +++ b/src/KOKKOS/meam_setup_done_kokkos.h @@ -0,0 +1,71 @@ +#include "meam_kokkos.h" + +template +void MEAMKokkos::meam_setup_done(void) +{ + MemoryKokkos *memoryKK = (MemoryKokkos *)memory; + + memoryKK->destroy_kokkos(k_phirar6,phirar6); + memoryKK->destroy_kokkos(k_phirar5,phirar5); + memoryKK->destroy_kokkos(k_phirar4,phirar4); + memoryKK->destroy_kokkos(k_phirar3,phirar3); + memoryKK->destroy_kokkos(k_phirar2,phirar2); + memoryKK->destroy_kokkos(k_phirar1,phirar1); + memoryKK->destroy_kokkos(k_phirar,phirar); + memoryKK->destroy_kokkos(k_phir,phir); + + memoryKK->create_kokkos(k_phir, phir, (neltypes * (neltypes + 1)) / 2, nr, "pair:phir"); + memoryKK->create_kokkos(k_phirar, phirar, (neltypes * (neltypes + 1)) / 2, nr, "pair:phirar"); + memoryKK->create_kokkos(k_phirar1, phirar1, (neltypes * (neltypes + 1)) / 2, nr, "pair:phirar1"); + memoryKK->create_kokkos(k_phirar2, phirar2, (neltypes * (neltypes + 1)) / 2, nr, "pair:phirar2"); + memoryKK->create_kokkos(k_phirar3, phirar3, (neltypes * (neltypes + 1)) / 2, nr, "pair:phirar3"); + memoryKK->create_kokkos(k_phirar4, phirar4, (neltypes * (neltypes + 1)) / 2, nr, "pair:phirar4"); + memoryKK->create_kokkos(k_phirar5, phirar5, (neltypes * (neltypes + 1)) / 2, nr, "pair:phirar5"); + memoryKK->create_kokkos(k_phirar6, phirar6, (neltypes * (neltypes + 1)) / 2, nr, "pair:phirar6"); + + h_phir = k_phir.h_view; + h_phirar = k_phirar.h_view; + h_phirar1 = k_phirar1.h_view; + h_phirar2 = k_phirar2.h_view; + h_phirar3 = k_phirar3.h_view; + h_phirar4 = k_phirar4.h_view; + h_phirar5 = k_phirar5.h_view; + h_phirar6 = k_phirar6.h_view; + + for (int i = 0; i <(neltypes * (neltypes + 1)) / 2; i++) + for(int j = 0; j < nr; j++) + { + h_phir(i,j) = phir[i][j]; + h_phirar(i,j) = phirar[i][j]; + h_phirar1(i,j) = phirar1[i][j]; + h_phirar2(i,j) = phirar2[i][j]; + h_phirar3(i,j) = phirar3[i][j]; + h_phirar4(i,j) = phirar4[i][j]; + h_phirar5(i,j) = phirar5[i][j]; + h_phirar6(i,j) = phirar6[i][j]; + } + k_phir.template modify(); + k_phir.template sync(); + d_phir = k_phir.template view(); + k_phirar.template modify(); + k_phirar.template sync(); + d_phirar = k_phirar.template view(); + k_phirar1.template modify(); + k_phirar1.template sync(); + d_phirar1 = k_phirar1.template view(); + k_phirar2.template modify(); + k_phirar2.template sync(); + d_phirar2 = k_phirar2.template view(); + k_phirar3.template modify(); + k_phirar3.template sync(); + d_phirar3 = k_phirar3.template view(); + k_phirar4.template modify(); + k_phirar4.template sync(); + d_phirar4 = k_phirar4.template view(); + k_phirar5.template modify(); + k_phirar5.template sync(); + d_phirar5 = k_phirar5.template view(); + k_phirar6.template modify(); + k_phirar6.template sync(); + d_phirar6 = k_phirar6.template view(); +} diff --git a/src/KOKKOS/pair_meam_kokkos.cpp b/src/KOKKOS/pair_meam_kokkos.cpp new file mode 100644 index 0000000000..38386d0a7a --- /dev/null +++ b/src/KOKKOS/pair_meam_kokkos.cpp @@ -0,0 +1,633 @@ +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +/* ---------------------------------------------------------------------- + Contributing author: Greg Wagner (SNL) +------------------------------------------------------------------------- */ + +#include +#include +#include +#include +//KK* +#include "meam_kokkos.h" +#include "kokkos.h" +#include "pair_kokkos.h" +//#include "pair_meamc.h" + +#include "pair_meam_kokkos.h" +#include "atom_kokkos.h" +//*KK +#include "force.h" +#include "comm.h" +//KK* +//#include "memory.h" +#include "memory_kokkos.h" +//*KK +#include "neighbor.h" +//KK* +//#include "neigh_list.h" +#include "neigh_list_kokkos.h" +//*KK +#include "neigh_request.h" +#include "error.h" +//*KK +#include "atom_masks.h" +//*KK + +using namespace LAMMPS_NS; + +#if 0 +static const int nkeywords = 21; +static const char *keywords[] = { + "Ec","alpha","rho0","delta","lattce", + "attrac","repuls","nn2","Cmin","Cmax","rc","delr", + "augt1","gsmooth_factor","re","ialloy", + "mixture_ref_t","erose_form","zbl", + "emb_lin_neg","bkgd_dyn"}; +#endif + +/* ---------------------------------------------------------------------- */ +template +PairMEAMKokkos::PairMEAMKokkos(LAMMPS *lmp) : PairMEAM(lmp) +{ + respa_enable = 0; + + atomKK = (AtomKokkos *) atom; + execution_space = ExecutionSpaceFromDevice::space; + datamask_read = X_MASK | F_MASK | TYPE_MASK | ENERGY_MASK | VIRIAL_MASK; + datamask_modify = F_MASK | ENERGY_MASK | VIRIAL_MASK; + meam_inst_kk = new MEAMKokkos(memory); + delete meam_inst; + meam_inst = meam_inst_kk; +} +/* ---------------------------------------------------------------------- */ + +template +PairMEAMKokkos::~PairMEAMKokkos() +{ + if (!copymode) { + memoryKK->destroy_kokkos(k_eatom,eatom); + memoryKK->destroy_kokkos(k_vatom,vatom); + delete meam_inst_kk; + } +} + +/* ---------------------------------------------------------------------- */ + +/* ---------------------------------------------------------------------- */ +template +void PairMEAMKokkos::compute(int eflag_in, int vflag_in) +{ + eflag = eflag_in; + vflag = vflag_in; + + if (neighflag == FULL) no_virial_fdotr_compute = 1; + + ev_init(eflag,vflag,0); + + // reallocate per-atom arrays if necessary + + if (eflag_atom) { + memoryKK->destroy_kokkos(k_eatom,eatom); + memoryKK->create_kokkos(k_eatom,eatom,maxeatom,"pair:eatom"); + d_eatom = k_eatom.view(); + } + if (vflag_atom) { + memoryKK->destroy_kokkos(k_vatom,vatom); + memoryKK->create_kokkos(k_vatom,vatom,maxvatom,6,"pair:vatom"); + d_vatom = k_vatom.view(); + } + + atomKK->sync(execution_space,datamask_read); + if (eflag || vflag) atomKK->modified(execution_space,datamask_modify); + else atomKK->modified(execution_space,F_MASK); + + + // neighbor list info + + NeighListKokkos* k_halflist = static_cast*>(listhalf); + int inum_half = listhalf->inum; + int* numneigh_half = listhalf->numneigh; + int* ilist_half = listhalf->ilist; + + d_ilist_half = k_halflist->d_ilist; + d_numneigh_half = k_halflist->d_numneigh; + d_neighbors_half = k_halflist->d_neighbors; + NeighListKokkos* k_fulllist = static_cast*>(listfull); + d_numneigh_full = k_fulllist->d_numneigh; + d_neighbors_full = k_fulllist->d_neighbors; + + copymode = 1; + + // strip neighbor lists of any special bond flags before using with MEAM + // necessary before doing neigh_f2c and neigh_c2f conversions each step + if (neighbor->ago == 0) { + Kokkos::parallel_for(Kokkos::RangePolicy(0,inum_half),*this); + } + + // check size of scrfcn based on half neighbor list + + nlocal = atom->nlocal; + nall = nlocal + atom->nghost; + + int n = 0; + //for (ii = 0; ii < inum_half; ii++) n += numneigh_half[ilist_half[ii]]; + Kokkos::parallel_reduce(Kokkos::RangePolicy(0,inum_half), *this, n); + + meam_inst_kk->meam_dens_setup(atom->nmax, nall, n); + + //double **x = atom->x; + x = atomKK->k_x.view(); + + //double **f = atom->f; + f = atomKK->k_f.view(); + + //int *type = atom->type; + type = atomKK->k_type.view(); + + int ntype = atom->ntypes; + + // 3 stages of MEAM calculation + // loop over my atoms followed by communication + + int offset = 0; + int errorflag = 0; +#if 0 + for (ii = 0; ii < inum_half; ii++) { + i = ilist_half[ii]; + meam_inst->meam_dens_init(i,ntype,type,map,x, + numneigh_half[i],firstneigh_half[i], + numneigh_full[i],firstneigh_full[i], + offset); + offset += numneigh_half[i]; + } +#endif + // To do: create the cumulative offset array in host and device + + k_offset = DAT::tdual_int_1d("pair:offset",inum_half+1); + h_offset = k_offset.h_view; + d_offset = k_offset.template view(); + ArrayTypes::t_int_1d h_ilist; + ArrayTypes::t_int_1d h_numneigh; + h_ilist = Kokkos::create_mirror_view(k_halflist->d_ilist); + h_numneigh = Kokkos::create_mirror_view(k_halflist->d_numneigh); + Kokkos::deep_copy(h_ilist,k_halflist->d_ilist); + Kokkos::deep_copy(h_numneigh,k_halflist->d_numneigh); + + h_offset[0] = 0; + for (int ii = 0; ii < inum_half; ii++) { + int i = h_ilist[ii]; + h_offset[ii+1] = h_offset[ii] + h_numneigh[i]; + } + k_offset.template modify(); + k_offset.template sync(); + meam_inst_kk->meam_dens_init(inum_half,ntype,type,d_map,x,d_numneigh_half,d_numneigh_full,&offset,d_ilist_half,d_neighbors_half, d_neighbors_full, d_offset, neighflag); + meam_inst_kk->k_rho0.template modify(); + meam_inst_kk->k_rho0.template sync(); + + meam_inst_kk->k_arho2b.template modify(); + meam_inst_kk->k_arho2b.template sync(); + + meam_inst_kk->k_arho1.template modify(); + meam_inst_kk->k_arho1.template sync(); + + meam_inst_kk->k_arho2.template modify(); + meam_inst_kk->k_arho2.template sync(); + + meam_inst_kk->k_arho3.template modify(); + meam_inst_kk->k_arho3.template sync(); + + meam_inst_kk->k_arho3b.template modify(); + meam_inst_kk->k_arho3b.template sync(); + + meam_inst_kk->k_t_ave.template modify(); + meam_inst_kk->k_t_ave.template sync(); + + meam_inst_kk->k_tsq_ave.template modify(); + meam_inst_kk->k_tsq_ave.template sync(); + + comm->reverse_comm(this); + + meam_inst_kk->k_rho0.template modify(); + meam_inst_kk->k_rho0.template sync(); + + meam_inst_kk->k_arho2b.template modify(); + meam_inst_kk->k_arho2b.template sync(); + + meam_inst_kk->k_arho1.template modify(); + meam_inst_kk->k_arho1.template sync(); + + meam_inst_kk->k_arho2.template modify(); + meam_inst_kk->k_arho2.template sync(); + + meam_inst_kk->k_arho3.template modify(); + meam_inst_kk->k_arho3.template sync(); + + meam_inst_kk->k_arho3b.template modify(); + meam_inst_kk->k_arho3b.template sync(); + + meam_inst_kk->k_t_ave.template modify(); + meam_inst_kk->k_t_ave.template sync(); + + meam_inst_kk->k_tsq_ave.template modify(); + meam_inst_kk->k_tsq_ave.template sync(); + + + meam_inst_kk->meam_dens_final(nlocal,eflag_either,eflag_global,eflag_atom, + &eng_vdwl,d_eatom,ntype,type,d_map,errorflag); + if (errorflag) { + char str[128]; + sprintf(str,"MEAM library error %d",errorflag); + error->one(FLERR,str); + } + + comm->forward_comm(this); + + offset = 0; + + // vptr is first value in vatom if it will be used by meam_force() + // else vatom may not exist, so pass dummy ptr + +#if 0 // To do: is this correct? vflag_atom is used to access vatom + typename ArrayTypes::t_virial_array vptr; + if (vflag_atom) vptr = d_vatom; + else vptr = NULL; + for (ii = 0; ii < inum_half; ii++) { + i = ilist_half[ii]; + meam_inst->meam_force(i,eflag_either,eflag_global,eflag_atom, + vflag_atom,&eng_vdwl,eatom,ntype,type,map,x, + numneigh_half[i],firstneigh_half[i], + numneigh_full[i],firstneigh_full[i], + offset,f,vptr); + offset += numneigh_half[i]; + } +#endif + meam_inst_kk->meam_force(inum_half, eflag_either,eflag_global,eflag_atom, + vflag_atom,&eng_vdwl,d_eatom,ntype,type,d_map,x, + d_numneigh_half, d_numneigh_full,f,d_vatom,d_ilist_half, d_offset, d_neighbors_half, d_neighbors_full, neighflag); + + if (vflag_fdotr) pair_virial_fdotr_compute(this); + if (eflag_atom) { + k_eatom.template modify(); + k_eatom.template sync(); + } + + if (vflag_atom) { + k_vatom.template modify(); + k_vatom.template sync(); + } + +} + +/* ---------------------------------------------------------------------- + set coeffs for one or more type pairs +------------------------------------------------------------------------- */ +template +void PairMEAMKokkos::coeff(int narg, char **arg) +{ + PairMEAM::coeff(narg,arg); + + //sync map + + int n = atom->ntypes; + k_map = DAT::tdual_int_1d("pair:map",n+1); + HAT::t_int_1d h_map = k_map.h_view; + + for (int i = 1; i <= n; i++) + h_map[i] = map[i]; + + k_map.template modify(); + k_map.template sync(); + + d_map = k_map.template view(); + + // To do: need to synchronize phirar variables + + meam_inst_kk->meam_setup_done(); + +} + +/* ---------------------------------------------------------------------- + init specific to this pair style +------------------------------------------------------------------------- */ +template +void PairMEAMKokkos::init_style() +{ + + PairMEAM::init_style(); + + neighflag = lmp->kokkos->neighflag; + auto request = neighbor->find_request(this); + + // MEAM needs both a full and half neighbor list? Not sure how to get that. + if (!(neighflag == FULL || neighflag == HALF || neighflag == HALFTHREAD)) + error->all(FLERR, "Cannot use chosen neighbor list style with pair meam/kk"); + + request->set_kokkos_host(std::is_same::value && + !std::is_same::value); + request->set_kokkos_device(std::is_same::value); + if (neighflag == FULL) request->enable_full(); + +} + +/* ---------------------------------------------------------------------- */ +template +int PairMEAMKokkos::pack_forward_comm_kokkos(int n, DAT::tdual_int_2d k_sendlist, int iswap_in, DAT::tdual_xfloat_1d &buf, + int pbc_flag, int *pbc) +{ + d_sendlist = k_sendlist.view(); + iswap = iswap_in; + v_buf = buf.view(); + Kokkos::parallel_for(Kokkos::RangePolicy(0,n),*this); + return n; +} + +template +KOKKOS_INLINE_FUNCTION +void PairMEAMKokkos::operator()(TagPairMEAMPackForwardComm, const int &i) const { + int j = d_sendlist(iswap, i); + int m = i*38; + v_buf[m++] = meam_inst_kk->d_rho0[j]; + v_buf[m++] = meam_inst_kk->d_rho1[j]; + v_buf[m++] = meam_inst_kk->d_rho2[j]; + v_buf[m++] = meam_inst_kk->d_rho3[j]; + v_buf[m++] = meam_inst_kk->d_frhop[j]; + v_buf[m++] = meam_inst_kk->d_gamma[j]; + v_buf[m++] = meam_inst_kk->d_dgamma1[j]; + v_buf[m++] = meam_inst_kk->d_dgamma2[j]; + v_buf[m++] = meam_inst_kk->d_dgamma3[j]; + v_buf[m++] = meam_inst_kk->d_arho2b[j]; + v_buf[m++] = meam_inst_kk->d_arho1(j,0); + v_buf[m++] = meam_inst_kk->d_arho1(j,1); + v_buf[m++] = meam_inst_kk->d_arho1(j,2); + v_buf[m++] = meam_inst_kk->d_arho2(j,0); + v_buf[m++] = meam_inst_kk->d_arho2(j,1); + v_buf[m++] = meam_inst_kk->d_arho2(j,2); + v_buf[m++] = meam_inst_kk->d_arho2(j,3); + v_buf[m++] = meam_inst_kk->d_arho2(j,4); + v_buf[m++] = meam_inst_kk->d_arho2(j,5); + for (int k = 0; k < 10; k++) v_buf[m++] = meam_inst_kk->d_arho3(j,k); + v_buf[m++] = meam_inst_kk->d_arho3b(j,0); + v_buf[m++] = meam_inst_kk->d_arho3b(j,1); + v_buf[m++] = meam_inst_kk->d_arho3b(j,2); + v_buf[m++] = meam_inst_kk->d_t_ave(j,0); + v_buf[m++] = meam_inst_kk->d_t_ave(j,1); + v_buf[m++] = meam_inst_kk->d_t_ave(j,2); + v_buf[m++] = meam_inst_kk->d_tsq_ave(j,0); + v_buf[m++] = meam_inst_kk->d_tsq_ave(j,1); + v_buf[m++] = meam_inst_kk->d_tsq_ave(j,2); +} + +/* ---------------------------------------------------------------------- */ +template +void PairMEAMKokkos::unpack_forward_comm_kokkos(int n, int first_in, DAT::tdual_xfloat_1d &buf) +{ + first = first_in; + v_buf = buf.view(); + Kokkos::parallel_for(Kokkos::RangePolicy(0,n),*this); +} + +template +KOKKOS_INLINE_FUNCTION +void PairMEAMKokkos::operator()(TagPairMEAMUnpackForwardComm, const int &i) const{ + int m = i*38; + + meam_inst_kk->d_rho0[i+first] = v_buf[m++]; + meam_inst_kk->d_rho1[i+first] = v_buf[m++]; + meam_inst_kk->d_rho2[i+first] = v_buf[m++]; + meam_inst_kk->d_rho3[i+first] = v_buf[m++]; + meam_inst_kk->d_frhop[i+first] = v_buf[m++]; + meam_inst_kk->d_gamma[i+first] = v_buf[m++]; + meam_inst_kk->d_dgamma1[i+first] = v_buf[m++]; + meam_inst_kk->d_dgamma2[i+first] = v_buf[m++]; + meam_inst_kk->d_dgamma3[i+first] = v_buf[m++]; + meam_inst_kk->d_arho2b[i+first] = v_buf[m++]; + meam_inst_kk->d_arho1(i+first,0) = v_buf[m++]; + meam_inst_kk->d_arho1(i+first,1) = v_buf[m++]; + meam_inst_kk->d_arho1(i+first,2) = v_buf[m++]; + meam_inst_kk->d_arho2(i+first,0) = v_buf[m++]; + meam_inst_kk->d_arho2(i+first,1) = v_buf[m++]; + meam_inst_kk->d_arho2(i+first,2) = v_buf[m++]; + meam_inst_kk->d_arho2(i+first,3) = v_buf[m++]; + meam_inst_kk->d_arho2(i+first,4) = v_buf[m++]; + meam_inst_kk->d_arho2(i+first,5) = v_buf[m++]; + for (int k = 0; k < 10; k++) meam_inst_kk->d_arho3(i+first,k) = v_buf[m++]; + meam_inst_kk->d_arho3b(i+first,0) = v_buf[m++]; + meam_inst_kk->d_arho3b(i+first,1) = v_buf[m++]; + meam_inst_kk->d_arho3b(i+first,2) = v_buf[m++]; + meam_inst_kk->d_t_ave(i+first,0) = v_buf[m++]; + meam_inst_kk->d_t_ave(i+first,1) = v_buf[m++]; + meam_inst_kk->d_t_ave(i+first,2) = v_buf[m++]; + meam_inst_kk->d_tsq_ave(i+first,0) = v_buf[m++]; + meam_inst_kk->d_tsq_ave(i+first,1) = v_buf[m++]; + meam_inst_kk->d_tsq_ave(i+first,2) = v_buf[m++]; + } + +template +int PairMEAMKokkos::pack_forward_comm(int n, int *list, double *buf, + int pbc_flag, int *pbc) +{ + int i,j,k,m; + + m = 0; + + for (i = 0; i < n; i++) { + j = list[i]; + buf[m++] = meam_inst_kk->h_rho0[j]; + buf[m++] = meam_inst_kk->h_rho1[j]; + buf[m++] = meam_inst_kk->h_rho2[j]; + buf[m++] = meam_inst_kk->h_rho3[j]; + buf[m++] = meam_inst_kk->h_frhop[j]; + buf[m++] = meam_inst_kk->h_gamma[j]; + buf[m++] = meam_inst_kk->h_dgamma1[j]; + buf[m++] = meam_inst_kk->h_dgamma2[j]; + buf[m++] = meam_inst_kk->h_dgamma3[j]; + buf[m++] = meam_inst_kk->h_arho2b[j]; + buf[m++] = meam_inst_kk->h_arho1(j,0); + buf[m++] = meam_inst_kk->h_arho1(j,1); + buf[m++] = meam_inst_kk->h_arho1(j,2); + buf[m++] = meam_inst_kk->h_arho2(j,0); + buf[m++] = meam_inst_kk->h_arho2(j,1); + buf[m++] = meam_inst_kk->h_arho2(j,2); + buf[m++] = meam_inst_kk->h_arho2(j,3); + buf[m++] = meam_inst_kk->h_arho2(j,4); + buf[m++] = meam_inst_kk->h_arho2(j,5); + for (k = 0; k < 10; k++) buf[m++] = meam_inst_kk->h_arho3(j,k); + buf[m++] = meam_inst_kk->h_arho3b(j,0); + buf[m++] = meam_inst_kk->h_arho3b(j,1); + buf[m++] = meam_inst_kk->h_arho3b(j,2); + buf[m++] = meam_inst_kk->h_t_ave(j,0); + buf[m++] = meam_inst_kk->h_t_ave(j,1); + buf[m++] = meam_inst_kk->h_t_ave(j,2); + buf[m++] = meam_inst_kk->h_tsq_ave(j,0); + buf[m++] = meam_inst_kk->h_tsq_ave(j,1); + buf[m++] = meam_inst_kk->h_tsq_ave(j,2); + } + + return m; +} + +template +void PairMEAMKokkos::unpack_forward_comm(int n, int first, double *buf) +{ + int i,k,m,last; + + m = 0; + last = first + n; + for (i = first; i < last; i++) { + meam_inst_kk->h_rho0[i] = buf[m++]; + meam_inst_kk->h_rho1[i] = buf[m++]; + meam_inst_kk->h_rho2[i] = buf[m++]; + meam_inst_kk->h_rho3[i] = buf[m++]; + meam_inst_kk->h_frhop[i] = buf[m++]; + meam_inst_kk->h_gamma[i] = buf[m++]; + meam_inst_kk->h_dgamma1[i] = buf[m++]; + meam_inst_kk->h_dgamma2[i] = buf[m++]; + meam_inst_kk->h_dgamma3[i] = buf[m++]; + meam_inst_kk->h_arho2b[i] = buf[m++]; + meam_inst_kk->h_arho1(i,0) = buf[m++]; + meam_inst_kk->h_arho1(i,1) = buf[m++]; + meam_inst_kk->h_arho1(i,2) = buf[m++]; + meam_inst_kk->h_arho2(i,0) = buf[m++]; + meam_inst_kk->h_arho2(i,1) = buf[m++]; + meam_inst_kk->h_arho2(i,2) = buf[m++]; + meam_inst_kk->h_arho2(i,3) = buf[m++]; + meam_inst_kk->h_arho2(i,4) = buf[m++]; + meam_inst_kk->h_arho2(i,5) = buf[m++]; + for (k = 0; k < 10; k++) meam_inst_kk->h_arho3(i,k) = buf[m++]; + meam_inst_kk->h_arho3b(i,0) = buf[m++]; + meam_inst_kk->h_arho3b(i,1) = buf[m++]; + meam_inst_kk->h_arho3b(i,2) = buf[m++]; + meam_inst_kk->h_t_ave(i,0) = buf[m++]; + meam_inst_kk->h_t_ave(i,1) = buf[m++]; + meam_inst_kk->h_t_ave(i,2) = buf[m++]; + meam_inst_kk->h_tsq_ave(i,0) = buf[m++]; + meam_inst_kk->h_tsq_ave(i,1) = buf[m++]; + meam_inst_kk->h_tsq_ave(i,2) = buf[m++]; + } +} + +/* ---------------------------------------------------------------------- */ +template +int PairMEAMKokkos::pack_reverse_comm(int n, int first, double *buf) +{ + int i,k,m,last; + + m = 0; + last = first + n; + for (i = first; i < last; i++) { + buf[m++] = meam_inst_kk->h_rho0[i]; + buf[m++] = meam_inst_kk->h_arho2b[i]; + buf[m++] = meam_inst_kk->h_arho1(i,0); + buf[m++] = meam_inst_kk->h_arho1(i,1); + buf[m++] = meam_inst_kk->h_arho1(i,2); + buf[m++] = meam_inst_kk->h_arho2(i,0); + buf[m++] = meam_inst_kk->h_arho2(i,1); + buf[m++] = meam_inst_kk->h_arho2(i,2); + buf[m++] = meam_inst_kk->h_arho2(i,3); + buf[m++] = meam_inst_kk->h_arho2(i,4); + buf[m++] = meam_inst_kk->h_arho2(i,5); + for (k = 0; k < 10; k++) buf[m++] = meam_inst_kk->h_arho3(i,k); + buf[m++] = meam_inst_kk->h_arho3b(i,0); + buf[m++] = meam_inst_kk->h_arho3b(i,1); + buf[m++] = meam_inst_kk->h_arho3b(i,2); + buf[m++] = meam_inst_kk->h_t_ave(i,0); + buf[m++] = meam_inst_kk->h_t_ave(i,1); + buf[m++] = meam_inst_kk->h_t_ave(i,2); + buf[m++] = meam_inst_kk->h_tsq_ave(i,0); + buf[m++] = meam_inst_kk->h_tsq_ave(i,1); + buf[m++] = meam_inst_kk->h_tsq_ave(i,2); + } + + return m; +} + +/* ---------------------------------------------------------------------- */ +template +void PairMEAMKokkos::unpack_reverse_comm(int n, int *list, double *buf) +{ + int i,j,k,m; + + m = 0; + for (i = 0; i < n; i++) { + j = list[i]; + meam_inst_kk->h_rho0[j] += buf[m++]; + meam_inst_kk->h_arho2b[j] += buf[m++]; + meam_inst_kk->h_arho1(j,0) += buf[m++]; + meam_inst_kk->h_arho1(j,1) += buf[m++]; + meam_inst_kk->h_arho1(j,2) += buf[m++]; + meam_inst_kk->h_arho2(j,0) += buf[m++]; + meam_inst_kk->h_arho2(j,1) += buf[m++]; + meam_inst_kk->h_arho2(j,2) += buf[m++]; + meam_inst_kk->h_arho2(j,3) += buf[m++]; + meam_inst_kk->h_arho2(j,4) += buf[m++]; + meam_inst_kk->h_arho2(j,5) += buf[m++]; + for (k = 0; k < 10; k++) meam_inst_kk->h_arho3(j,k) += buf[m++]; + meam_inst_kk->h_arho3b(j,0) += buf[m++]; + meam_inst_kk->h_arho3b(j,1) += buf[m++]; + meam_inst_kk->h_arho3b(j,2) += buf[m++]; + meam_inst_kk->h_t_ave(j,0) += buf[m++]; + meam_inst_kk->h_t_ave(j,1) += buf[m++]; + meam_inst_kk->h_t_ave(j,2) += buf[m++]; + meam_inst_kk->h_tsq_ave(j,0) += buf[m++]; + meam_inst_kk->h_tsq_ave(j,1) += buf[m++]; + meam_inst_kk->h_tsq_ave(j,2) += buf[m++]; + } +} + +/* ---------------------------------------------------------------------- + memory usage of local atom-based arrays +------------------------------------------------------------------------- */ +template +double PairMEAMKokkos::memory_usage() +{ + double bytes = 11 * meam_inst_kk->nmax * sizeof(double); + bytes += (3 + 6 + 10 + 3 + 3 + 3) * meam_inst_kk->nmax * sizeof(double); + bytes += 3 * meam_inst_kk->maxneigh * sizeof(double); + return bytes; +} +template +KOKKOS_INLINE_FUNCTION +void PairMEAMKokkos::operator()(TagPairMEAMKernelNeighStrip, const int &ii) const { +/* ---------------------------------------------------------------------- + * strip special bond flags from neighbor list entries + * are not used with MEAM + * need to do here so Fortran lib doesn't see them + * done once per reneighbor so that neigh_f2c and neigh_c2f don't see them + * ------------------------------------------------------------------------- */ + const int i = d_ilist_half[ii]; + const int jnum_half = d_numneigh_half[i]; + const int jnum_full = d_numneigh_full[i]; + for (int jj = 0; jj < jnum_half; jj++) { + d_neighbors_half(i,jj) &= NEIGHMASK; + } + for (int jj = 0; jj < jnum_full; jj++) { + d_neighbors_full(i,jj) &= NEIGHMASK; + } +} + +template +KOKKOS_INLINE_FUNCTION +void PairMEAMKokkos::operator()(TagPairMEAMKernelA, const int ii, int &n) const { + const int i = d_ilist_half[ii]; + n += d_numneigh_half[i]; +} + +namespace LAMMPS_NS { +template class PairMEAMKokkos; +#ifdef KOKKOS_ENABLE_CUDA +template class PairMEAMKokkos; +#endif +} + diff --git a/src/KOKKOS/pair_meam_kokkos.h b/src/KOKKOS/pair_meam_kokkos.h new file mode 100644 index 0000000000..114f4a1665 --- /dev/null +++ b/src/KOKKOS/pair_meam_kokkos.h @@ -0,0 +1,166 @@ +/* -*- c++ -*- ---------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#ifdef PAIR_CLASS + +PairStyle(meam/c/kk,PairMEAMKokkos) +PairStyle(meam/c/kk/device,PairMEAMKokkos) +PairStyle(meam/c/kk/host,PairMEAMKokkos) +PairStyle(meam/kk,PairMEAMKokkos) +PairStyle(meam/kk/device,PairMEAMKokkos) +PairStyle(meam/kk/host,PairMEAMKokkos) + +#else + +#ifndef LMP_PAIR_MEAMC_KOKKOS_H +#define LMP_PAIR_MEAMC_KOKKOS_H + +#include "kokkos_base.h" +#include "pair_kokkos.h" +#include "pair_meam.h" +#include "neigh_list_kokkos.h" +#include "meam_kokkos.h" + + +namespace LAMMPS_NS { +struct TagPairMEAMKernelNeighStrip{}; +struct TagPairMEAMKernelA{}; +struct TagPairMEAMPackForwardComm{}; +struct TagPairMEAMUnpackForwardComm{}; + +template +class MEAMKokkos; + +template +class PairMEAMKokkos : public PairMEAM, public KokkosBase { + public: + enum {EnabledNeighFlags=FULL|HALFTHREAD|HALF}; + enum {COUL_FLAG=0}; + typedef DeviceType device_type; + typedef ArrayTypes AT; + //typedef EV_FLOAT value_type; + + PairMEAMKokkos(class LAMMPS *); + virtual ~PairMEAMKokkos(); + void compute(int, int); + void coeff(int, char **); + void init_style(); + + KOKKOS_INLINE_FUNCTION + void operator()(TagPairMEAMPackForwardComm, const int&) const; + + KOKKOS_INLINE_FUNCTION + void operator()(TagPairMEAMUnpackForwardComm, const int&) const; + + KOKKOS_INLINE_FUNCTION + void operator()(TagPairMEAMKernelNeighStrip, const int&) const; + + KOKKOS_INLINE_FUNCTION + void operator()(TagPairMEAMKernelA, const int, int&) const; + + int pack_forward_comm_kokkos(int, DAT::tdual_int_2d, int, DAT::tdual_xfloat_1d&, + int, int *); + void unpack_forward_comm_kokkos(int, int, DAT::tdual_xfloat_1d&); + int pack_forward_comm(int, int *, double *, int, int *); + void unpack_forward_comm(int, int, double *); + int pack_reverse_comm(int, int, double *); + void unpack_reverse_comm(int, int *, double *); + double memory_usage(); + + protected: + class MEAMKokkos *meam_inst_kk; + typename AT::t_x_array_randomread x; + typename AT::t_f_array f; + typename AT::t_int_1d_randomread type; + + DAT::tdual_efloat_1d k_eatom; + DAT::tdual_virial_array k_vatom; + typename ArrayTypes::t_efloat_1d d_eatom; + typename ArrayTypes::t_virial_array d_vatom; + + DAT::tdual_int_1d k_offset; + HAT::t_int_1d h_offset; + typename AT::t_int_1d_randomread d_offset; + + DAT::tdual_int_1d k_map; + typename AT::t_int_1d_randomread d_map; + typename AT::t_int_1d_randomread d_ilist_half; + typename AT::t_int_1d_randomread d_numneigh_half; + typename AT::t_neighbors_2d d_neighbors_half; + typename AT::t_int_1d_randomread d_numneigh_full; + typename AT::t_neighbors_2d d_neighbors_full; + typename AT::t_int_2d d_sendlist; + typename AT::t_xfloat_1d_um v_buf; + + int neighflag,nlocal,nall,eflag,vflag; + int iswap; + int first; + + friend void pair_virial_fdotr_compute(PairMEAMKokkos*); + +}; + +} + +#endif +#endif + +/* ERROR/WARNING messages: + +E: MEAM library error %d + +A call to the MEAM Fortran library returned an error. + +E: Illegal ... command + +Self-explanatory. Check the input script syntax and compare to the +documentation for the command. You can use -echo screen as a +command-line option when running LAMMPS to see the offending line. + +E: Incorrect args for pair coefficients + +Self-explanatory. Check the input script or data file. + +E: Pair style MEAM requires newton pair on + +See the newton command. This is a restriction to use the MEAM +potential. + +E: Cannot open MEAM potential file %s + +The specified MEAM potential file cannot be opened. Check that the +path and name are correct. + +E: Incorrect format in MEAM potential file + +Incorrect number of words per line in the potential file. + +E: Unrecognized lattice type in MEAM file 1 + +The lattice type in an entry of the MEAM library file is not +valid. + +E: Did not find all elements in MEAM library file + +The requested elements were not found in the MEAM file. + +E: Keyword %s in MEAM parameter file not recognized + +Self-explanatory. + +E: Unrecognized lattice type in MEAM file 2 + +The lattice type in an entry of the MEAM parameter file is not +valid. + +*/ diff --git a/src/MEAM/meam.h b/src/MEAM/meam.h index 237ffed8aa..8b94ac0084 100644 --- a/src/MEAM/meam.h +++ b/src/MEAM/meam.h @@ -29,7 +29,7 @@ class MEAM { MEAM(Memory *mem); ~MEAM(); - private: + protected: Memory *memory; // cutforce = force cutoff diff --git a/src/MEAM/pair_meam.cpp b/src/MEAM/pair_meam.cpp index 7dcb16d3f6..ab027dcb89 100644 --- a/src/MEAM/pair_meam.cpp +++ b/src/MEAM/pair_meam.cpp @@ -73,6 +73,8 @@ PairMEAM::PairMEAM(LAMMPS *lmp) : Pair(lmp) PairMEAM::~PairMEAM() { + if (copymode) return; + delete meam_inst; if (allocated) { diff --git a/src/MEAM/pair_meam.h b/src/MEAM/pair_meam.h index eea3893309..ffe8045ac9 100644 --- a/src/MEAM/pair_meam.h +++ b/src/MEAM/pair_meam.h @@ -43,7 +43,7 @@ class PairMEAM : public Pair { void unpack_reverse_comm(int, int *, double *) override; double memory_usage() override; - private: + protected: class MEAM *meam_inst; double cutmax; // max cutoff for all elements int nlibelements; // # of library elements @@ -52,7 +52,7 @@ class PairMEAM : public Pair { double **scale; // scaling factor for adapt - void allocate(); + virtual void allocate(); void read_files(const std::string &, const std::string &); void read_global_meam_file(const std::string &); void read_user_meam_file(const std::string &); From 33f4bb525b58ed5fd90e6ccbd477412afefe0713 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 13 Jun 2022 17:43:40 -0400 Subject: [PATCH 342/585] remove redundant condition --- src/INTERLAYER/pair_ilp_tmd.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/INTERLAYER/pair_ilp_tmd.cpp b/src/INTERLAYER/pair_ilp_tmd.cpp index 15e1beede7..52119cbf12 100644 --- a/src/INTERLAYER/pair_ilp_tmd.cpp +++ b/src/INTERLAYER/pair_ilp_tmd.cpp @@ -483,7 +483,7 @@ void PairILPTMD::calc_normal() } } //############################ For the edge atoms of TMD ################################ - else if (cont > 1 && cont < Nnei) { + else if (cont < Nnei) { if (strcmp(elements[itype], "Mo") == 0 || strcmp(elements[itype], "W") == 0 || strcmp(elements[itype], "S") == 0 || strcmp(elements[itype], "Se") == 0) { // derivatives of Ni[l] respect to the cont neighbors From 407e015c80ec46c23a188747035360eec0317aeb Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Mon, 13 Jun 2022 15:46:58 -0600 Subject: [PATCH 343/585] more doc page edits for enhanced fix mdi/qm command --- doc/src/Commands_fix.rst | 2 +- doc/src/Howto_mdi.rst | 18 +- doc/src/fix.rst | 2 +- doc/src/fix_latte.rst | 9 +- doc/src/fix_mdi_aimd.rst | 138 ----------- doc/src/fix_mdi_qm.rst | 232 +++++++++++++++++++ doc/src/mdi.rst | 4 +- src/MDI/{fix_mdi_aimd.cpp => fix_mdi_qm.cpp} | 63 +++-- src/MDI/{fix_mdi_aimd.h => fix_mdi_qm.h} | 12 +- 9 files changed, 297 insertions(+), 183 deletions(-) delete mode 100644 doc/src/fix_mdi_aimd.rst create mode 100644 doc/src/fix_mdi_qm.rst rename src/MDI/{fix_mdi_aimd.cpp => fix_mdi_qm.cpp} (86%) rename src/MDI/{fix_mdi_aimd.h => fix_mdi_qm.h} (89%) diff --git a/doc/src/Commands_fix.rst b/doc/src/Commands_fix.rst index 7dc3f324b4..e7a9f71b79 100644 --- a/doc/src/Commands_fix.rst +++ b/doc/src/Commands_fix.rst @@ -103,7 +103,7 @@ OPT. * :doc:`lb/viscous ` * :doc:`lineforce ` * :doc:`manifoldforce ` - * :doc:`mdi/aimd ` + * :doc:`mdi/qm ` * :doc:`meso/move ` * :doc:`mol/swap ` * :doc:`momentum (k) ` diff --git a/doc/src/Howto_mdi.rst b/doc/src/Howto_mdi.rst index f5aab0be22..f9147f44d9 100644 --- a/doc/src/Howto_mdi.rst +++ b/doc/src/Howto_mdi.rst @@ -63,12 +63,18 @@ The package also provides a :doc:`mdi plugin ` command which enables LAMMPS to operate as an MDI driver and load an MDI engine as a plugin library. -The package also has a `fix mdi/aimd ` command in which -LAMMPS operates as an MDI driver to perform *ab initio* MD simulations -in conjunction with a quantum mechanics code. Its post_force() method -illustrates how a driver issues MDI commands to another code. This -command can be used to couple to an MDI engine which is either a -stand-alone code or a plugin library. +The package also has a `fix mdi/qm ` command in which +LAMMPS operates as an MDI driver in conjunction with a quantum +mechanics code as an MDI engine. The post_force() method of the +fix_mdi_qm.cpp file shows how a driver issues MDI commands to another +code. This command can be used to couple to an MDI engine which is +either a stand-alone code or a plugin library. + +As explained on the `fix mdi/qm ` command doc page, it can +be used to perform *ab initio* MD simulations or energy minimizations, +or to evalute the quantum energy and forces for a series of +independent systems. The examples/mdi directory has example input +scripts for all of these use cases. ---------- diff --git a/doc/src/fix.rst b/doc/src/fix.rst index b0ec47fbe6..ad3fbef77b 100644 --- a/doc/src/fix.rst +++ b/doc/src/fix.rst @@ -246,7 +246,7 @@ accelerated styles exist. * :doc:`lb/viscous ` - * :doc:`lineforce ` - constrain atoms to move in a line * :doc:`manifoldforce ` - restrain atoms to a manifold during minimization -* :doc:`mdi/aimd ` - LAMMPS operates as driver for ab initio MD (AIMD) via the MolSSI Driver Interface (MDI) +* :doc:`mdi/qm ` - LAMMPS operates as driver for a quantum code via the MolSSI Driver Interface (MDI) * :doc:`meso/move ` - move mesoscopic SPH/SDPD particles in a prescribed fashion * :doc:`mol/swap ` - Monte Carlo atom type swapping with a molecule * :doc:`momentum ` - zero the linear and/or angular momentum of a group of atoms diff --git a/doc/src/fix_latte.rst b/doc/src/fix_latte.rst index f75d44e3a4..8a6315fa48 100644 --- a/doc/src/fix_latte.rst +++ b/doc/src/fix_latte.rst @@ -116,13 +116,6 @@ potential energy of the system as part of :doc:`thermodynamic output `. The default setting for this fix is :doc:`fix_modify energy yes `. -The :doc:`fix_modify ` *virial* option is supported by -this fix to add the contribution compute by LATTE to the global -pressure of the system via the :doc:`compute pressure -` command. This can be accessed by -:doc:`thermodynamic output `. The default setting for -this fix is :doc:`fix_modify virial yes `. - The :doc:`fix_modify ` *virial* option is supported by this fix to add the contribution computed by LATTE to the global pressure of the system as part of :doc:`thermodynamic output @@ -137,7 +130,7 @@ energy discussed above. The scalar value calculated by this fix is No parameter of this fix can be used with the *start/stop* keywords of the :doc:`run ` command. -The DFTB forces computed by LATTE via this fix are imposed during an +The DFTB forces computed by LATTE via this fix are used during an energy minimization, invoked by the :doc:`minimize ` command. diff --git a/doc/src/fix_mdi_aimd.rst b/doc/src/fix_mdi_aimd.rst deleted file mode 100644 index 7b87f369d7..0000000000 --- a/doc/src/fix_mdi_aimd.rst +++ /dev/null @@ -1,138 +0,0 @@ -.. index:: fix mdi/qm - -fix mdi/qm command -====================== - -Syntax -"""""" - -.. parsed-literal:: - - fix ID group-ID mdi/qm keyword - -* ID, group-ID are documented in :doc:`fix ` command -* mdi/qm = style name of this fix command -* zero or more keyword/value pairs may be appended -* keyword = *plugin* or *every* or *add* - - .. parsed-literal:: - - *plugin* args = none - *every* args = Nevery - Nevery = request values from server code once every Nevery steps - *add* args = *yes* or *no* - yes = add returned value from server code to LAMMPS quantities - no = do not add returned values to LAMMPS quantities - -Examples -"""""""" - -.. code-block:: LAMMPS - - fix 1 all mdi/aimd - fix 1 all mdi/aimd plugin - -Description -""""""""""" - -This command enables LAMMPS to act as a client with another server -code that will compute the total energy, per-atom forces, and total -virial for atom conformations and simulation box size/shapes that -LAMMPS sends it. - -Typically the server code will be a quantum code, hence the name of -the fix. However this is not required, the server code could be -another classical molecular dynamics code or LAMMPS itself. The -server code must support use of the `MDI Library -`_ as -explained below. - -Example use cases for this fix are the following (discussed further -below): - -* perform an ab intitio MD (AIMD) simulation with quantum forces -* perform an energy minimziation with quantum forces -* perform a nudged elatic band (NEB) calculation with quantum forces -* requests a QM calculation for a series of independent systems which LAMMPS reads or generates - -The code coupling performed by this command is done via the `MDI -Library `_. -LAMMPS runs as an MDI driver (client), and sends MDI commands to an -external MDI engine code (server), e.g. a quantum code which has -support for MDI. See the :doc:`Howto mdi ` page for more -information about how LAMMPS can operate as either an MDI driver or -engine. - -The examples/mdi directory contains input scripts using this fix, with -two instances of LAMMPS acting as both a driver and an engine -(surrogate for a QM code). The examples/mdi/README file explains how -to launch two driver and engine codes so that they communicate using -the MDI library via either MPI or sockets. Any QM code that supports -MDI could be used in place of LAMMPS acting as a QM surrogate. See -the :doc:`Howto mdi ` page for a current list (March 2022) -of such QM codes. - -Engine codes can support MDI in either or both of two ways. It can -support being used as a stand-alone code, launched at the same time as -LAMMPS. Or it can support being used as a plugin library, which -LAMMPS loads. See the :doc:`mdi plugin ` command for how to -trigger LAMMPS to load the plugin library. The examples/mdi/README -file explains both use cases: launching both the driver and engine as -stand-alone codes or having the driver code load an engine as a plugin -library. - ----------- - - - -To use this fix with a plugin engine, you must specify the -*plugin* keyword as the last argument, as illustrated above. - - ----------- - ----------- - -This fix performs the timestepping portion of anAIMD simulation. -Both LAMMPS and the engine code (QM or LAMMPS) should define the same -system (simulation box, atoms and their types) in their respective -input scripts. LAMMPS then begins its timestepping. - -At the point in each timestep when LAMMPS needs the force on each -atom, it communicates with the engine code. It sends the current -simulation box size and shape (if they change dynamically, e.g. during -an NPT simulation), and the current atom coordinates. The engine code -computes quantum forces on each atom and returns them to LAMMPS. If -LAMMPS also needs the system energy and/or virial, it requests those -values from the engine code as well. - -Restrictions -"""""""""""" - -This command is part of the MDI package. It is only enabled if -LAMMPS was built with that package. See the :doc:`Build package -` page for more info. - -Stored values by fix: energy, per-atoms forces, virial. - - - -To use LAMMPS as an MDI driver in conjunction with other MDI-enabled -atomistic codes, the :doc:`units ` command should be used to -specify *real* or *metal* units. This will ensure the correct unit -conversions between LAMMPS and MDI units. The other code will also -perform similar unit conversions into its preferred units. - -LAMMPS can also be used as an MDI driver in other unit choices it -supports, e.g. *lj*, but then no unit conversion is performed. - -Related commands -"""""""""""""""" - -:doc:`mdi engine ` - -Default -""""""" - -The default for the optional keywords is add = yes, every = 1. - diff --git a/doc/src/fix_mdi_qm.rst b/doc/src/fix_mdi_qm.rst new file mode 100644 index 0000000000..c0d3d69932 --- /dev/null +++ b/doc/src/fix_mdi_qm.rst @@ -0,0 +1,232 @@ +.. index:: fix mdi/qm + +fix mdi/qm command +====================== + +Syntax +"""""" + +.. parsed-literal:: + + fix ID group-ID mdi/qm keyword + +* ID, group-ID are documented in :doc:`fix ` command +* mdi/qm = style name of this fix command +* zero or more keyword/value pairs may be appended +* keyword = *add* or *every* + + .. parsed-literal:: + + *add* args = *yes* or *no* + yes = add returned value from server code to LAMMPS quantities + no = do not add returned values to LAMMPS quantities + *every* args = Nevery + Nevery = request values from server code once every Nevery steps + +Examples +"""""""" + +.. code-block:: LAMMPS + + fix 1 all mdi/qm + fix 1 all mdi/qm add no every 100 + +Description +""""""""""" + +This command enables LAMMPS to act as a client with another server +code that will compute the total energy, per-atom forces, and total +virial for atom conformations and simulation box size/shapes that +LAMMPS sends it. + +Typically the server code will be a quantum mechanics (QM) code, hence +the name of the fix. However this is not required, the server code +could be another classical molecular dynamics code or LAMMPS itself. +The server code must support use of the `MDI Library +`_ as +explained below. + +These are example use cases for this fix, discussed further below: + +* perform an ab intitio MD (AIMD) simulation with quantum forces +* perform an energy minimziation with quantum forces +* perform a nudged elatic band (NEB) calculation with quantum forces +* perform a QM calculation for a series of independent systems which LAMMPS reads or generates + +The code coupling performed by this command is done via the `MDI +Library `_. +LAMMPS runs as an MDI driver (client), and sends MDI commands to an +external MDI engine code (server), e.g. a QM code which has support +for MDI. See the :doc:`Howto mdi ` page for more +information about how LAMMPS can operate as either an MDI driver or +engine. + +The examples/mdi directory contains input scripts using this fix in +the various use cases listed above. In each case, two instances of +LAMMPS are used, once as an MDI driver, once as an MDI engine +(surrogate for a QM code). The examples/mdi/README file explains how +to launch two codes so that they communicate via the MDI library using +either MPI or sockets. Any QM code that supports MDI could be used in +place of LAMMPS acting as a QM surrogate. See the :doc:`Howto mdi +` page for a current list (March 2022) of such QM codes. + +Note that an engine code can support MDI in either or both of two +modes. It can be used as a stand-alone code, launched at the same +time as LAMMPS. Or it can be used as a plugin library, which LAMMPS +loads. See the :doc:`mdi plugin ` command for how to trigger +LAMMPS to load a plugin library. The examples/mdi/README file +explains how to launch the two codes in either mode. + +---------- + +The *add* keyword setting of *yes* or *no* determines whether the +energy and forces returned by the QM code will be added to the LAMMPS +internal energy and forces or not. If the setting is *no* then the +default :doc:`fix_modify energy ` and :doc:`fix_modify +virial ` settings are also set to *no* and your input +scripts should not set them to yes. See more details on these +fix_modify settings below. + +Whatever the setting for the *add* keyword, the QM energy, forces, and +virial will be stored by the fix, so they can be accessed by other +commands. See details below. + +The *every* keyword determines how often the QM code will be invoked +during a dynamics run with the current LAMMPS simulation box and +configuration of atoms. The QM code will be called once every +*Nevery* timesteps. + +---------- + +3 example use cases: + +(1) To run an ab initio MD (AIMD) dynamics simulation, or an energy +minimization with QM forces, or a multi-replica NEB calculation, use +*add yes* and *every 1* (the defaults). This is so that every time +LAMMPS needs energy and forces, the QM code will be invoked. + +Both LAMMPS and the QM code should define the same system (simulation +box, atoms and their types) in their respective input scripts. Note +that on this scenario, it may not be necessary for LAMMPS to define a +pair style or use a neighbor list. + +LAMMPS will then perform the timestepping for the simulation. At the +point in each timestep when LAMMPS needs the force on each atom, it +communicates with the engine code. It sends the current simulation +box size and shape (if they change dynamically, e.g. during an NPT +simulation), and the current atom coordinates. The engine code +computes quantum forces on each atom and returns them to LAMMPS. If +LAMMPS also needs the system energy and/or virial, it requests those +values from the engine code as well. + +(2) To run dynamics with a LAMMPS interatomic potential, and evaluate +the QM energy and forces once every 1000 steps, use *add no* and +*every 1000*. This could be useful for using an MD run to generate +randomized configurations which then generate QM data for training a +machine learning potential. A :doc:`dump custom ` command could +be invoked every 1000 steps to dump the atom coordinates and QM forces +to a file. Likewise the QM energy could be output with the +:doc:`thermo_style custom ` command. + +(3) To do a QM evaulation of energy and forces for a series of *N* +independent systems (simulation box and atoms), use *add no* and +*every 1*. Write a LAMMPS input script which loops over the *N* +systems. See the :doc:`Howto multiple ` doc page for +details on looping and removing old systems. The series of systems +could be initialized by reading them from data files with +:doc:`read_data ` commands. Or, for example, by using the +:doc:`lattice ` , :doc:`create_atoms `, +:doc:`delete_atoms `, and/or :doc:`displace_atoms +random ` commands to generate a series of different +systems. At the end of the loop perform :doc:`run 0 ` +and :doc:`write_dump ` commands to invoke the QM code +and output the QM energy and forces. As in (2) this be useful +to generate QM data for training a machine learning potential. + +---------- + +Restart, fix_modify, output, run start/stop, minimize info +""""""""""""""""""""""""""""""""""""""""""""""""""""""""""" + +No information about this fix is written to :doc:`binary restart files +`. + +The :doc:`fix_modify ` *energy* option is supported by +this fix to add the potential energy computed by the QM code to the +global potential energy of the system as part of :doc:`thermodynamic +output `. The default setting for this fix is +:doc:`fix_modify energy yes `, unless the *add* keyword is +set to *no*, in which case the default setting is *no*. + +The :doc:`fix_modify ` *virial* option is supported by +this fix to add the contribution computed by the QM code to the global +pressure of the system as part of :doc:`thermodynamic output +`. The default setting for this fix is :doc:`fix_modify +virial yes `, unless the *add* keyword is set to *no*, in +which case the default setting is *no*. + +This fix computes a global scalar which can be accessed by various +:doc:`output commands `. The scalar is the energy +returned by the QM code. The scalar value calculated by this fix is +"extensive". + +This fix also computes a global vector with of length 6 which contains +the symmetric virial tensor values returned by the QM code. It can +likewise be accessed by various :doc:`output commands `. + +The ordering of values in the symmetric virial tensor is as follows: +vxx, vyy, vzz, vxy, vxz, vyz. The values will be in pressure +:doc:`units `. + +This fix also computes a peratom array with 3 columns which contains +the peratom forces returned by the QM code. It can likewise be +accessed by various :doc:`output commands `. + +No parameter of this fix can be used with the *start/stop* keywords of +the :doc:`run ` command. + +Assuming the *add* keyword is set to *yes* (the default), the forces +computed by the QM code are used during an energy minimization, +invoked by the :doc:`minimize ` command. + +.. note:: + + If you want the potential energy associated with the QM forces to + be included in the total potential energy of the system (the + quantity being minimized), you MUST not disable the + :doc:`fix_modify ` *energy* option for this fix, which + means the *add* keyword should also be set to *yes* (the default). + + +Restrictions +"""""""""""" + +This command is part of the MDI package. It is only enabled if +LAMMPS was built with that package. See the :doc:`Build package +` page for more info. + +The QM code does not currently compute and return per-atom energy or +per-atom virial contributions. So they will not show up as part of +the calculations performed by the :doc:`compute pe/atom +` or :doc:`compute stress/atom ` +commands. + +To use LAMMPS as an MDI driver in conjunction with other MDI-enabled +codes (MD or QM codes), the :doc:`units ` command should be +used to specify *real* or *metal* units. This will ensure the correct +unit conversions between LAMMPS and MDI units. The other code will +also perform similar unit conversions into its preferred units. + +LAMMPS can also be used as an MDI driver in other unit choices it +supports, e.g. *lj*, but then no unit conversion is performed. + +Related commands +"""""""""""""""" + +:doc:`mdi plugin `, :doc:`mdi engine ` + +Default +""""""" + +The default for the optional keywords is add = yes, every = 1. + diff --git a/doc/src/mdi.rst b/doc/src/mdi.rst index 3a6f0234fc..73e245697e 100644 --- a/doc/src/mdi.rst +++ b/doc/src/mdi.rst @@ -270,7 +270,7 @@ The *command* keyword is required. It specifies a LAMMPS input script command (as a single argument in quotes if it is multiple words). Once the plugin library is launched, LAMMPS will execute this command. Other previously-defined commands in the input script, such as the -:doc:`fix mdi/aimd ` command, should perform MDI +:doc:`fix mdi/qm ` command, should perform MDI communication with the engine, while the specified *command* executes. Note that if *command* is an :doc:`include ` command, then it could specify a filename with multiple LAMMPS commands. @@ -304,7 +304,7 @@ supports, e.g. *lj*, but then no unit conversion is performed. Related commands """""""""""""""" -:doc:`fix mdi/aimd ` +:doc:`fix mdi/qm ` Default """"""" diff --git a/src/MDI/fix_mdi_aimd.cpp b/src/MDI/fix_mdi_qm.cpp similarity index 86% rename from src/MDI/fix_mdi_aimd.cpp rename to src/MDI/fix_mdi_qm.cpp index c878d183d3..2f38864198 100644 --- a/src/MDI/fix_mdi_aimd.cpp +++ b/src/MDI/fix_mdi_qm.cpp @@ -11,7 +11,7 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include "fix_mdi_aimd.h" +#include "fix_mdi_qm.h" #include "atom.h" #include "comm.h" #include "domain.h" @@ -27,10 +27,8 @@ enum { NATIVE, REAL, METAL }; // LAMMPS units which MDI supports /* ---------------------------------------------------------------------- */ -FixMDIAimd::FixMDIAimd(LAMMPS *lmp, int narg, char **arg) : Fix(lmp, narg, arg) +FixMDIQM::FixMDIQM(LAMMPS *lmp, int narg, char **arg) : Fix(lmp, narg, arg) { - if (narg != 3) error->all(FLERR, "Illegal fix mdi/aimd command"); - scalar_flag = 1; global_freq = 1; extscalar = 1; @@ -40,8 +38,8 @@ FixMDIAimd::FixMDIAimd(LAMMPS *lmp, int narg, char **arg) : Fix(lmp, narg, arg) // check requirements for LAMMPS to work with MDI as an engine - if (atom->tag_enable == 0) error->all(FLERR, "Cannot use MDI engine without atom IDs"); - + if (atom->tag_enable == 0) + error->all(FLERR, "Cannot use MDI engine without atom IDs"); if (atom->natoms && atom->tag_consecutive() == 0) error->all(FLERR, "MDI engine requires consecutive atom IDs"); @@ -50,7 +48,28 @@ FixMDIAimd::FixMDIAimd(LAMMPS *lmp, int narg, char **arg) : Fix(lmp, narg, arg) int role; MDI_Get_role(&role); if (role != MDI_DRIVER) - error->all(FLERR, "Must invoke LAMMPS as an MDI driver to use fix mdi/aimd"); + error->all(FLERR, "Must invoke LAMMPS as an MDI driver to use fix mdi/qm"); + + // optional args + + addflag = 1; + every = 1; + + int iarg = 3; + while (iarg < narg) { + if (strcmp(arg[iarg],"add") == 0) { + if (iarg+2 > narg) error->all(FLERR,"Illegal fix mdi/qm command"); + if (strcmp(arg[iarg],"yes") == 0) addflag = 1; + else if (strcmp(arg[iarg],"no") == 0) addflag = 0; + else error->all(FLERR,"Illegal fix mdi/qm command"); + iarg += 2; + } else if (strcmp(arg[iarg],"every") == 0) { + if (iarg+2 > narg) error->all(FLERR,"Illegal fix mdi/qm command"); + every = utils::inumeric(FLERR,arg[iarg+1],false,lmp); + if (every < 0) error->all(FLERR,"Illegal fix mdi/qm command"); + iarg += 2; + } else error->all(FLERR,"Illegal fix mdi/qm command"); + } // mdicomm will be one-time initialized in init() // cannot be done here for a plugin library, b/c mdi plugin command is later @@ -78,7 +97,7 @@ FixMDIAimd::FixMDIAimd(LAMMPS *lmp, int narg, char **arg) : Fix(lmp, narg, arg) /* ---------------------------------------------------------------------- */ -FixMDIAimd::~FixMDIAimd() +FixMDIQM::~FixMDIQM() { // send exit command to engine if it is a stand-alone code // for plugin, this happens in MDIPlugin::plugin_wrapper() @@ -96,7 +115,7 @@ FixMDIAimd::~FixMDIAimd() /* ---------------------------------------------------------------------- */ -int FixMDIAimd::setmask() +int FixMDIQM::setmask() { int mask = 0; mask |= PRE_REVERSE; @@ -107,7 +126,7 @@ int FixMDIAimd::setmask() /* ---------------------------------------------------------------------- */ -void FixMDIAimd::init() +void FixMDIQM::init() { if (mdicomm != MDI_COMM_NULL) return; @@ -120,25 +139,27 @@ void FixMDIAimd::init() if (mdicomm == MDI_COMM_NULL) { plugin = 0; MDI_Accept_communicator(&mdicomm); - if (mdicomm == MDI_COMM_NULL) error->all(FLERR, "MDI unable to connect to stand-alone engine"); + if (mdicomm == MDI_COMM_NULL) + error->all(FLERR, "MDI unable to connect to stand-alone engine"); } else { plugin = 1; int method; MDI_Get_method(&method, mdicomm); - if (method != MDI_PLUGIN) error->all(FLERR, "MDI internal error for plugin engine"); + if (method != MDI_PLUGIN) + error->all(FLERR, "MDI internal error for plugin engine"); } } /* ---------------------------------------------------------------------- */ -void FixMDIAimd::setup(int vflag) +void FixMDIQM::setup(int vflag) { post_force(vflag); } /* ---------------------------------------------------------------------- */ -void FixMDIAimd::setup_pre_reverse(int eflag, int vflag) +void FixMDIQM::setup_pre_reverse(int eflag, int vflag) { pre_reverse(eflag, vflag); } @@ -147,14 +168,14 @@ void FixMDIAimd::setup_pre_reverse(int eflag, int vflag) store eflag, so can use it in post_force to request energy ------------------------------------------------------------------------- */ -void FixMDIAimd::pre_reverse(int eflag, int /*vflag*/) +void FixMDIQM::pre_reverse(int eflag, int /*vflag*/) { eflag_caller = eflag; } /* ---------------------------------------------------------------------- */ -void FixMDIAimd::post_force(int vflag) +void FixMDIQM::post_force(int vflag) { int ilocal, ierr; double cell[9]; @@ -266,7 +287,7 @@ void FixMDIAimd::post_force(int vflag) /* ---------------------------------------------------------------------- */ -void FixMDIAimd::min_post_force(int vflag) +void FixMDIQM::min_post_force(int vflag) { post_force(vflag); } @@ -275,7 +296,7 @@ void FixMDIAimd::min_post_force(int vflag) energy from MDI engine ------------------------------------------------------------------------- */ -double FixMDIAimd::compute_scalar() +double FixMDIQM::compute_scalar() { return engine_energy; } @@ -284,12 +305,12 @@ double FixMDIAimd::compute_scalar() reallocate storage for all atoms if necessary ------------------------------------------------------------------------- */ -void FixMDIAimd::reallocate() +void FixMDIQM::reallocate() { if (atom->natoms <= maxbuf) return; if (3 * atom->natoms > MAXSMALLINT) - error->all(FLERR, "Natoms too large to use with fix mdi/aimd"); + error->all(FLERR, "Natoms too large to use with fix mdi/qm"); maxbuf = atom->natoms; @@ -304,7 +325,7 @@ void FixMDIAimd::reallocate() MDI to/from LAMMPS conversion factors ------------------------------------------------------------------------- */ -void FixMDIAimd::unit_conversions() +void FixMDIQM::unit_conversions() { double angstrom_to_bohr, kelvin_to_hartree, ev_to_hartree, second_to_aut; diff --git a/src/MDI/fix_mdi_aimd.h b/src/MDI/fix_mdi_qm.h similarity index 89% rename from src/MDI/fix_mdi_aimd.h rename to src/MDI/fix_mdi_qm.h index cdb7977c37..88b6a3cd8c 100644 --- a/src/MDI/fix_mdi_aimd.h +++ b/src/MDI/fix_mdi_qm.h @@ -13,22 +13,22 @@ #ifdef FIX_CLASS // clang-format off -FixStyle(mdi/aimd,FixMDIAimd); +FixStyle(mdi/qm,FixMDIQM); // clang-format on #else -#ifndef LMP_FIX_MDI_AIMD_H -#define LMP_FIX_MDI_AIMD_H +#ifndef LMP_FIX_MDI_QM_H +#define LMP_FIX_MDI_QM_H #include "fix.h" #include namespace LAMMPS_NS { -class FixMDIAimd : public Fix { +class FixMDIQM : public Fix { public: - FixMDIAimd(class LAMMPS *, int, char **); - ~FixMDIAimd(); + FixMDIQM(class LAMMPS *, int, char **); + ~FixMDIQM(); int setmask(); void init(); From c53e53d701ece2c8a66339cb43f1f5046c355b30 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 13 Jun 2022 17:47:20 -0400 Subject: [PATCH 344/585] must set `suffix` variable only when suffixflag is true --- lib/latte/Install.py | 5 ++--- 1 file changed, 2 insertions(+), 3 deletions(-) diff --git a/lib/latte/Install.py b/lib/latte/Install.py index 94879ff4a0..2e8f9bee8d 100644 --- a/lib/latte/Install.py +++ b/lib/latte/Install.py @@ -71,7 +71,8 @@ buildflag = args.build pathflag = args.path is not None version = args.version suffixflag = args.machine is not None -suffix = args.machine +if suffixflag: + suffix = args.machine if pathflag: lattedir = args.path @@ -132,8 +133,6 @@ os.symlink(os.path.join(lattedir, 'src', 'latte_c_bind.o'), 'filelink.o') # copy Makefile.lammps.suffix to Makefile.lammps if suffixflag or not os.path.exists("Makefile.lammps"): - if suffix is None: - suffix = 'gfortran' print("Creating Makefile.lammps") if os.path.exists("Makefile.lammps.%s" % suffix): shutil.copyfile("Makefile.lammps.%s" % suffix, 'Makefile.lammps') From 0f5ae6d48c2a55ffbd097175c16303da23cd6f57 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 13 Jun 2022 22:00:36 -0400 Subject: [PATCH 345/585] remove references to "plugin" options from fix mdi/aimd --- doc/src/fix_mdi_aimd.rst | 10 ---------- 1 file changed, 10 deletions(-) diff --git a/doc/src/fix_mdi_aimd.rst b/doc/src/fix_mdi_aimd.rst index 64bc4a3d6a..9ab2a933ed 100644 --- a/doc/src/fix_mdi_aimd.rst +++ b/doc/src/fix_mdi_aimd.rst @@ -12,7 +12,6 @@ Syntax * ID, group-ID are documented in :doc:`fix ` command * mdi/aimd = style name of this fix command -* optional keyword = *plugin* Examples """""""" @@ -20,7 +19,6 @@ Examples .. code-block:: LAMMPS fix 1 all mdi/aimd - fix 1 all mdi/aimd plugin Description """"""""""" @@ -53,14 +51,6 @@ same time as LAMMPS, or as a plugin library. See the :doc:`mdi plugin Again, the examples/mdi/README file explains how to launch both driver and engine codes so that engine is used in plugin mode. -To use this fix with a plugin engine, you must specify the -*plugin* keyword as the last argument, as illustrated above. - -.. note:: - - As of April 2022, the *plugin* keyword is needed. In a future - version of the MDI library it will no longer be necessary. - ---------- This fix performs the timestepping portion of an AIMD simulation. From ea48dd30199436b3b230a806b89c26cd9653c1ad Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 13 Jun 2022 22:01:30 -0400 Subject: [PATCH 346/585] avoid file pointer leakage in dump reader base class. --- src/reader.cpp | 6 ++++++ src/reader.h | 1 + 2 files changed, 7 insertions(+) diff --git a/src/reader.cpp b/src/reader.cpp index c7b99260e7..025445ca24 100644 --- a/src/reader.cpp +++ b/src/reader.cpp @@ -28,6 +28,12 @@ Reader::Reader(LAMMPS *lmp) : Pointers(lmp) compressed = false; } +// avoid resource leak +Reader::~Reader() +{ + if (fp != nullptr) close_file(); +} + /* ---------------------------------------------------------------------- try to open given file generic version for ASCII files with optional compression or for native binary dumps diff --git a/src/reader.h b/src/reader.h index 93f9197b7a..753b6956f7 100644 --- a/src/reader.h +++ b/src/reader.h @@ -23,6 +23,7 @@ namespace LAMMPS_NS { class Reader : protected Pointers { public: Reader(class LAMMPS *); + ~Reader() override; virtual void settings(int, char **); From 423c511d7a4f4d2d5830bf2bfd1a9184df90ff1e Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 13 Jun 2022 22:10:43 -0400 Subject: [PATCH 347/585] use explicit scoping in destructor --- src/REAXFF/fix_acks2_reaxff.cpp | 4 ++-- src/REAXFF/fix_qeq_reaxff.cpp | 2 +- 2 files changed, 3 insertions(+), 3 deletions(-) diff --git a/src/REAXFF/fix_acks2_reaxff.cpp b/src/REAXFF/fix_acks2_reaxff.cpp index bd93dec0b7..be71bc761f 100644 --- a/src/REAXFF/fix_acks2_reaxff.cpp +++ b/src/REAXFF/fix_acks2_reaxff.cpp @@ -94,8 +94,8 @@ FixACKS2ReaxFF::~FixACKS2ReaxFF() memory->destroy(s_hist_X); memory->destroy(s_hist_last); - deallocate_storage(); - deallocate_matrix(); + FixACKS2ReaxFF::deallocate_storage(); + FixACKS2ReaxFF::deallocate_matrix(); } /* ---------------------------------------------------------------------- */ diff --git a/src/REAXFF/fix_qeq_reaxff.cpp b/src/REAXFF/fix_qeq_reaxff.cpp index aeeee7b71a..1b9d33c3d5 100644 --- a/src/REAXFF/fix_qeq_reaxff.cpp +++ b/src/REAXFF/fix_qeq_reaxff.cpp @@ -163,7 +163,7 @@ FixQEqReaxFF::~FixQEqReaxFF() memory->destroy(t_hist); FixQEqReaxFF::deallocate_storage(); - deallocate_matrix(); + FixQEqReaxFF::deallocate_matrix(); memory->destroy(shld); From 26dcb649bbe6e36575e80e26b9a79db42794afdb Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 13 Jun 2022 22:10:51 -0400 Subject: [PATCH 348/585] remove redundant check --- src/create_bonds.cpp | 1 - 1 file changed, 1 deletion(-) diff --git a/src/create_bonds.cpp b/src/create_bonds.cpp index 7b3929db62..d316644e15 100644 --- a/src/create_bonds.cpp +++ b/src/create_bonds.cpp @@ -73,7 +73,6 @@ void CreateBonds::command(int narg, char **arg) iarg = 6; } else if (strcmp(arg[0], "single/bond") == 0) { style = SBOND; - if (narg < 4) error->all(FLERR, "Illegal create_bonds command"); btype = utils::inumeric(FLERR, arg[1], false, lmp); batom1 = utils::tnumeric(FLERR, arg[2], false, lmp); batom2 = utils::tnumeric(FLERR, arg[3], false, lmp); From 716a012dbe9d449501815be9cd1b97f50795a264 Mon Sep 17 00:00:00 2001 From: Jacob Gissinger Date: Tue, 14 Jun 2022 00:51:53 -0400 Subject: [PATCH 349/585] add keyword for 'delete species list' option also add check that only one sub-keyword is used --- src/REAXFF/fix_reaxff_species.cpp | 20 ++++++++++++-------- src/REAXFF/fix_reaxff_species.h | 2 +- 2 files changed, 13 insertions(+), 9 deletions(-) diff --git a/src/REAXFF/fix_reaxff_species.cpp b/src/REAXFF/fix_reaxff_species.cpp index 9f39afd793..4b84a85236 100644 --- a/src/REAXFF/fix_reaxff_species.cpp +++ b/src/REAXFF/fix_reaxff_species.cpp @@ -148,7 +148,7 @@ FixReaxFFSpecies::FixReaxFFSpecies(LAMMPS *lmp, int narg, char **arg) : Fix(lmp, eletype = nullptr; ele = filepos = filedel = nullptr; eleflag = posflag = padflag = 0; - delflag = masslimitflag = 0; + delflag = specieslistflag = masslimitflag = 0; singlepos_opened = multipos_opened = del_opened = 0; multipos = 0; @@ -188,7 +188,6 @@ FixReaxFFSpecies::FixReaxFFSpecies(LAMMPS *lmp, int narg, char **arg) : Fix(lmp, // delete species } else if (strcmp(arg[iarg],"delete") == 0) { delflag = 1; - filedel = new char[255]; strcpy(filedel,arg[iarg+1]); if (me == 0) { @@ -199,17 +198,19 @@ FixReaxFFSpecies::FixReaxFFSpecies(LAMMPS *lmp, int narg, char **arg) : Fix(lmp, del_opened = 1; if (strcmp(arg[iarg+2],"masslimit") == 0) { + if (iarg+5 > narg) error->all(FLERR,"Illegal fix reaxff/species command"); masslimitflag = 1; massmin = atof(arg[iarg+3]); massmax = atof(arg[iarg+4]); iarg += 5; - } else { - ndelspec = atoi(arg[iarg+2]); - if (iarg+ndelspec+3 > narg) error->all(FLERR,"Illegal fix reaxff/species command"); + } else if (strcmp(arg[iarg+2],"specieslist") == 0) { + specieslistflag = 1; + ndelspec = atoi(arg[iarg+3]); + if (iarg+ndelspec+4 > narg) error->all(FLERR,"Illegal fix reaxff/species command"); del_species.resize(ndelspec); for (int i = 0; i < ndelspec; i ++) - del_species[i] = arg[iarg+3+i]; + del_species[i] = arg[iarg+4+i]; if (me == 0) { fprintf(fdel,"Timestep"); @@ -217,9 +218,9 @@ FixReaxFFSpecies::FixReaxFFSpecies(LAMMPS *lmp, int narg, char **arg) : Fix(lmp, fprintf(fdel,"\t%s",del_species[i].c_str()); fprintf(fdel,"\n"); fflush(fdel); - } + } else error->all(FLERR, "Illegal fix reaxff/species command"); - iarg += ndelspec + 3; + iarg += ndelspec + 4; } // position of molecules @@ -255,6 +256,9 @@ FixReaxFFSpecies::FixReaxFFSpecies(LAMMPS *lmp, int narg, char **arg) : Fix(lmp, if (ntypes > 3) ele[3] = 'N'; } + if (delflag && specieslistflag && masslimitflag) + error->all(FLERR, "Illegal fix reaxff/species command"); + vector_nmole = 0; vector_nspec = 0; } diff --git a/src/REAXFF/fix_reaxff_species.h b/src/REAXFF/fix_reaxff_species.h index 64d408ed24..e272ff7d6c 100644 --- a/src/REAXFF/fix_reaxff_species.h +++ b/src/REAXFF/fix_reaxff_species.h @@ -59,7 +59,7 @@ class FixReaxFFSpecies : public Fix { FILE *fp, *pos, *fdel; int eleflag, posflag, multipos, padflag, setupflag; - int delflag, masslimitflag; + int delflag, specieslistflag, masslimitflag; double massmin, massmax; int singlepos_opened, multipos_opened, del_opened; char *ele, **eletype, *filepos, *filedel; From fbf9f62eef63eb5cf0ef359a3fb280a46d3c8660 Mon Sep 17 00:00:00 2001 From: Jacob Gissinger Date: Tue, 14 Jun 2022 01:18:46 -0400 Subject: [PATCH 350/585] add credits --- src/REAXFF/fix_reaxff_species.cpp | 1 + 1 file changed, 1 insertion(+) diff --git a/src/REAXFF/fix_reaxff_species.cpp b/src/REAXFF/fix_reaxff_species.cpp index 4b84a85236..5325086ef9 100644 --- a/src/REAXFF/fix_reaxff_species.cpp +++ b/src/REAXFF/fix_reaxff_species.cpp @@ -14,6 +14,7 @@ /* ---------------------------------------------------------------------- Contributing authors: Ray Shan (Sandia, tnshan@sandia.gov) Oleg Sergeev (VNIIA, sergeev@vniia.ru) + Jacob Gissinger (NASA, jacob.r.gissinger@gmail.com), 'delete' keyword ------------------------------------------------------------------------- */ #include "fix_reaxff_species.h" From f423c32f42def47cec706fa689373fc7d7bcd204 Mon Sep 17 00:00:00 2001 From: Jacob Gissinger Date: Tue, 14 Jun 2022 01:23:36 -0400 Subject: [PATCH 351/585] reaxff delete species docs --- doc/src/fix_reaxff_species.rst | 35 +++++++++++++++++++++++++++++++++- 1 file changed, 34 insertions(+), 1 deletion(-) diff --git a/doc/src/fix_reaxff_species.rst b/doc/src/fix_reaxff_species.rst index a652777ba7..208ee31009 100644 --- a/doc/src/fix_reaxff_species.rst +++ b/doc/src/fix_reaxff_species.rst @@ -20,7 +20,7 @@ Syntax * Nfreq = calculate average bond-order every this many timesteps * filename = name of output file * zero or more keyword/value pairs may be appended -* keyword = *cutoff* or *element* or *position* +* keyword = *cutoff* or *element* or *position* or *delete* .. parsed-literal:: @@ -31,6 +31,14 @@ Syntax *position* value = posfreq filepos posfreq = write position files every this many timestep filepos = name of position output file + *delete* value = filedel keyword value + filedel = name of delete species output file + keyword = *specieslist* or *masslimit* + *specieslist* value = Nspecies Species1 Species2 ... + Nspecies = number of species in list + *masslimit* value = massmin massmax + massmin = minimum molecular weight of species to delete + massmax = maximum molecular weight of species to delete Examples """""""" @@ -40,6 +48,7 @@ Examples fix 1 all reaxff/species 10 10 100 species.out fix 1 all reaxff/species 1 2 20 species.out cutoff 1 1 0.40 cutoff 1 2 0.55 fix 1 all reaxff/species 1 100 100 species.out element Au O H position 1000 AuOH.pos + fix 1 all reaxff/species 1 100 100 species.out delete species.del masslimit 0 50 Description """"""""""" @@ -104,6 +113,30 @@ character appears in *filepos*, then one file per snapshot is written at *posfreq* and the "\*" character is replaced with the timestep value. For example, AuO.pos.\* becomes AuO.pos.0, AuO.pos.1000, etc. +The optional keyword *delete* enables the periodic removal of +molecules from the system. Criteria for deletion can be either a list +of specific chemical formulae or a range of molecular weights. +Molecules are deleted every *Nfreq* timesteps, and bond connectivity +is determined using the *Nevery* and *Nrepeat* keywords. The +*filedel* argument is the name of the output file that records the +species that are removed from the system. The *specieslist* keyword +permits specific chemical species to be deleted. The *Nspecies* +argument specifies how many species are eligible for deletion and is +followed by a list of chemical formulae, whose strings are compared to +species identified by this fix. For example, "specieslist 2 CO CO2" +deletes molecules that are identified as "CO" and "CO2" in the species +output file. When using the *specieslist* keyword, the *filedel* file +has the following format: the first line lists the chemical formulae +eligible for deletion, and each additional line contains the timestep +on which a molecule deletion occurs and the number of each species +deleted on that timestep. The *masslimit* keyword permits deletion of +molecules with molecular weights between *massmin* and *massmax*. +When using the *masslimit* keyword, each line of the *filedel* file +contains the timestep on which deletions occurs, followed by how many +of each species are deleted (with quantities preceding chemical +formulae). The *specieslist* and *masslimit* keywords cannot both be +used in the same *reaxff/species* fix. + ---------- The *Nevery*, *Nrepeat*, and *Nfreq* arguments specify on what From 7a64d1358e25e13f9b5419636346ab00493ba66a Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 14 Jun 2022 10:36:11 -0400 Subject: [PATCH 352/585] remove unused module --- python/makewheel.py | 2 +- python/setup.py | 4 ++-- 2 files changed, 3 insertions(+), 3 deletions(-) diff --git a/python/makewheel.py b/python/makewheel.py index 64ecbe2464..a5b683aa63 100644 --- a/python/makewheel.py +++ b/python/makewheel.py @@ -1,6 +1,6 @@ #!/usr/bin/env python -import sys,os,shutil +import sys,os # find python script to activate the virtual environment and source it if sys.platform == 'win32': diff --git a/python/setup.py b/python/setup.py index 0097e3d596..7794119930 100644 --- a/python/setup.py +++ b/python/setup.py @@ -3,7 +3,7 @@ from setuptools import setup from setuptools.dist import Distribution from sys import version_info -import os,time,shutil +import os,time LAMMPS_PYTHON_DIR = os.path.dirname(os.path.realpath(__file__)) LAMMPS_DIR = os.path.dirname(LAMMPS_PYTHON_DIR) LAMMPS_SOURCE_DIR = os.path.join(LAMMPS_DIR, 'src') @@ -24,7 +24,7 @@ def get_lammps_version(): class BinaryDistribution(Distribution): """Wrapper to enforce creating a binary package""" - def has_ext_modules(foo): + def has_ext_modules(self): return True if version_info.major >= 3: From 6abb316dbad9e5c6298d8ae4e4a165a4ad25b765 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 14 Jun 2022 10:36:21 -0400 Subject: [PATCH 353/585] avoid resource leak --- src/DPD-SMOOTH/pair_sdpd_taitwater_isothermal.cpp | 3 ++- 1 file changed, 2 insertions(+), 1 deletion(-) diff --git a/src/DPD-SMOOTH/pair_sdpd_taitwater_isothermal.cpp b/src/DPD-SMOOTH/pair_sdpd_taitwater_isothermal.cpp index f5ccb15eac..7a36cdfc5c 100644 --- a/src/DPD-SMOOTH/pair_sdpd_taitwater_isothermal.cpp +++ b/src/DPD-SMOOTH/pair_sdpd_taitwater_isothermal.cpp @@ -44,7 +44,7 @@ static const double sqrt_2_inv = std::sqrt(0.5); /* ---------------------------------------------------------------------- */ PairSDPDTaitwaterIsothermal::PairSDPDTaitwaterIsothermal (LAMMPS *lmp) -: Pair (lmp) { +: Pair (lmp), random(nullptr) { restartinfo = 0; single_enable =0; } @@ -61,6 +61,7 @@ PairSDPDTaitwaterIsothermal::~PairSDPDTaitwaterIsothermal () { memory->destroy (soundspeed); memory->destroy (B); } + delete random; } /* ---------------------------------------------------------------------- */ From 2028c68becd9290dde3da700a7548521f7296233 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 14 Jun 2022 10:45:05 -0400 Subject: [PATCH 354/585] remove unused imports --- .../ELASTIC_T/BORN_MATRIX/Argon/Analytical/compute_born.py | 1 - examples/ELASTIC_T/BORN_MATRIX/Argon/Numdiff/compute_born.py | 1 - examples/mdi/aimd_driver.py | 5 ++--- lib/install_helpers.py | 2 +- 4 files changed, 3 insertions(+), 6 deletions(-) diff --git a/examples/ELASTIC_T/BORN_MATRIX/Argon/Analytical/compute_born.py b/examples/ELASTIC_T/BORN_MATRIX/Argon/Analytical/compute_born.py index 0f3265faeb..88cc8dcca2 100644 --- a/examples/ELASTIC_T/BORN_MATRIX/Argon/Analytical/compute_born.py +++ b/examples/ELASTIC_T/BORN_MATRIX/Argon/Analytical/compute_born.py @@ -1,7 +1,6 @@ #!/usr/bin/env python3 # -*- coding: utf-8 -*- -import sys import numpy as np def reduce_Born(Cf): diff --git a/examples/ELASTIC_T/BORN_MATRIX/Argon/Numdiff/compute_born.py b/examples/ELASTIC_T/BORN_MATRIX/Argon/Numdiff/compute_born.py index 0f3265faeb..88cc8dcca2 100644 --- a/examples/ELASTIC_T/BORN_MATRIX/Argon/Numdiff/compute_born.py +++ b/examples/ELASTIC_T/BORN_MATRIX/Argon/Numdiff/compute_born.py @@ -1,7 +1,6 @@ #!/usr/bin/env python3 # -*- coding: utf-8 -*- -import sys import numpy as np def reduce_Born(Cf): diff --git a/examples/mdi/aimd_driver.py b/examples/mdi/aimd_driver.py index 2d8fe10c1a..ee493ea31e 100644 --- a/examples/mdi/aimd_driver.py +++ b/examples/mdi/aimd_driver.py @@ -26,7 +26,7 @@ # -nsteps 5 # number of timesteps, default = 5 -import sys,math,random +import sys import mdi import numpy as np from mpi4py import MPI @@ -42,10 +42,9 @@ def error(txt=None): def perform_aimd(world,mm_comm,qm_comm): me = world.Get_rank() - nprocs = world.Get_size() # receive number of atoms from the MM engine - + mdi.MDI_Send_command(" Date: Tue, 14 Jun 2022 10:45:31 -0400 Subject: [PATCH 355/585] rename local variable shadowing a global one --- src/REAXFF/fix_qeq_reaxff.cpp | 10 +++++----- 1 file changed, 5 insertions(+), 5 deletions(-) diff --git a/src/REAXFF/fix_qeq_reaxff.cpp b/src/REAXFF/fix_qeq_reaxff.cpp index 1b9d33c3d5..48e93f682a 100644 --- a/src/REAXFF/fix_qeq_reaxff.cpp +++ b/src/REAXFF/fix_qeq_reaxff.cpp @@ -640,7 +640,7 @@ void FixQEqReaxFF::compute_H() int jnum; int i, j, ii, jj, flag; double dx, dy, dz, r_sqr; - const double SMALL = 0.0001; + constexpr double EPSILON = 0.0001; int *type = atom->type; tagint *tag = atom->tag; @@ -671,10 +671,10 @@ void FixQEqReaxFF::compute_H() if (j < atom->nlocal) flag = 1; else if (tag[i] < tag[j]) flag = 1; else if (tag[i] == tag[j]) { - if (dz > SMALL) flag = 1; - else if (fabs(dz) < SMALL) { - if (dy > SMALL) flag = 1; - else if (fabs(dy) < SMALL && dx > SMALL) + if (dz > EPSILON) flag = 1; + else if (fabs(dz) < EPSILON) { + if (dy > EPSILON) flag = 1; + else if (fabs(dy) < EPSILON && dx > EPSILON) flag = 1; } } From 34863c6c97ed8e88d4fe19d5c5aa36192cb398ca Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Tue, 14 Jun 2022 10:14:36 -0600 Subject: [PATCH 356/585] updates to fix_mdi_qm for multiple sims --- doc/src/fix_mdi_qm.rst | 68 ++++---- src/MDI/fix_mdi_qm.cpp | 341 +++++++++++++++++++++++++++-------------- src/MDI/fix_mdi_qm.h | 18 ++- src/MDI/mdi_engine.cpp | 40 ++--- src/MDI/mdi_plugin.cpp | 1 - 5 files changed, 297 insertions(+), 171 deletions(-) diff --git a/doc/src/fix_mdi_qm.rst b/doc/src/fix_mdi_qm.rst index c0d3d69932..5c66ac2639 100644 --- a/doc/src/fix_mdi_qm.rst +++ b/doc/src/fix_mdi_qm.rst @@ -13,10 +13,13 @@ Syntax * ID, group-ID are documented in :doc:`fix ` command * mdi/qm = style name of this fix command * zero or more keyword/value pairs may be appended -* keyword = *add* or *every* +* keyword = *virial* or *add* or *every* .. parsed-literal:: + *virial* args = *yes* or *no* + yes = request virial tensor from server code + no = do not request virial tensor from server code *add* args = *yes* or *no* yes = add returned value from server code to LAMMPS quantities no = do not add returned values to LAMMPS quantities @@ -29,6 +32,7 @@ Examples .. code-block:: LAMMPS fix 1 all mdi/qm + fix 1 all mdi/qm virial yes fix 1 all mdi/qm add no every 100 Description @@ -79,13 +83,17 @@ explains how to launch the two codes in either mode. ---------- +The *virial* keyword setting of yes or no determines whether +LAMMPS will request the QM code to also compute and return +a 6-element symmetric virial tensor for the system. + The *add* keyword setting of *yes* or *no* determines whether the -energy and forces returned by the QM code will be added to the LAMMPS -internal energy and forces or not. If the setting is *no* then the -default :doc:`fix_modify energy ` and :doc:`fix_modify -virial ` settings are also set to *no* and your input -scripts should not set them to yes. See more details on these -fix_modify settings below. +energy and forces and virial returned by the QM code will be added to +the LAMMPS internal energy and forces and virial or not. If the +setting is *no* then the default :doc:`fix_modify energy ` +and :doc:`fix_modify virial ` settings are also set to +*no* and your input scripts should not set them to yes. See more +details on these fix_modify settings below. Whatever the setting for the *add* keyword, the QM energy, forces, and virial will be stored by the fix, so they can be accessed by other @@ -103,30 +111,36 @@ configuration of atoms. The QM code will be called once every (1) To run an ab initio MD (AIMD) dynamics simulation, or an energy minimization with QM forces, or a multi-replica NEB calculation, use *add yes* and *every 1* (the defaults). This is so that every time -LAMMPS needs energy and forces, the QM code will be invoked. +LAMMPS needs energy and forces, the QM code will be invoked. Both LAMMPS and the QM code should define the same system (simulation box, atoms and their types) in their respective input scripts. Note that on this scenario, it may not be necessary for LAMMPS to define a pair style or use a neighbor list. -LAMMPS will then perform the timestepping for the simulation. At the -point in each timestep when LAMMPS needs the force on each atom, it -communicates with the engine code. It sends the current simulation -box size and shape (if they change dynamically, e.g. during an NPT -simulation), and the current atom coordinates. The engine code -computes quantum forces on each atom and returns them to LAMMPS. If -LAMMPS also needs the system energy and/or virial, it requests those -values from the engine code as well. +LAMMPS will then perform the timestepping or minimization iterations +for the simulation. At the point in each timestep or iteration when +LAMMPS needs the force on each atom, it communicates with the engine +code. It sends the current simulation box size and shape (if they +change dynamically, e.g. during an NPT simulation), and the current +atom coordinates. The engine code computes quantum forces on each +atom and the total energy of the system and returns them to LAMMPS. + +Note that if the AIMD simulation is an NPT or NPH model, or the energy +minimization includesf :doc:`fix box relax ` to +equilibrate the box size/shape, then LAMMPS computes a pressure. This +means the *virial* keyword should be set to *yes* so that the QM +contribution to the pressure can be included. (2) To run dynamics with a LAMMPS interatomic potential, and evaluate the QM energy and forces once every 1000 steps, use *add no* and *every 1000*. This could be useful for using an MD run to generate -randomized configurations which then generate QM data for training a -machine learning potential. A :doc:`dump custom ` command could -be invoked every 1000 steps to dump the atom coordinates and QM forces -to a file. Likewise the QM energy could be output with the -:doc:`thermo_style custom ` command. +randomized configurations which are then passed to the QM code to +produce training data for a machine learning potential. A :doc:`dump +custom ` command could be invoked every 1000 steps to dump the +atom coordinates and QM forces to a file. Likewise the QM energy and +virial could be output with the :doc:`thermo_style custom +` command. (3) To do a QM evaulation of energy and forces for a series of *N* independent systems (simulation box and atoms), use *add no* and @@ -138,10 +152,10 @@ could be initialized by reading them from data files with :doc:`lattice ` , :doc:`create_atoms `, :doc:`delete_atoms `, and/or :doc:`displace_atoms random ` commands to generate a series of different -systems. At the end of the loop perform :doc:`run 0 ` -and :doc:`write_dump ` commands to invoke the QM code -and output the QM energy and forces. As in (2) this be useful -to generate QM data for training a machine learning potential. +systems. At the end of the loop perform :doc:`run 0 ` and +:doc:`write_dump ` commands to invoke the QM code and +output the QM energy and forces. As in (2) this be useful to produce +QM data for training a machine learning potential. ---------- @@ -228,5 +242,5 @@ Related commands Default """"""" -The default for the optional keywords is add = yes, every = 1. - +The default for the optional keywords are virial = no, add = yes, +every = 1. diff --git a/src/MDI/fix_mdi_qm.cpp b/src/MDI/fix_mdi_qm.cpp index 2f38864198..7ef03f0e7a 100644 --- a/src/MDI/fix_mdi_qm.cpp +++ b/src/MDI/fix_mdi_qm.cpp @@ -29,13 +29,6 @@ enum { NATIVE, REAL, METAL }; // LAMMPS units which MDI supports FixMDIQM::FixMDIQM(LAMMPS *lmp, int narg, char **arg) : Fix(lmp, narg, arg) { - scalar_flag = 1; - global_freq = 1; - extscalar = 1; - energy_global_flag = 1; - virial_global_flag = 1; - thermo_energy = thermo_virial = 1; - // check requirements for LAMMPS to work with MDI as an engine if (atom->tag_enable == 0) @@ -52,12 +45,19 @@ FixMDIQM::FixMDIQM(LAMMPS *lmp, int narg, char **arg) : Fix(lmp, narg, arg) // optional args + virialflag = 0; addflag = 1; every = 1; int iarg = 3; while (iarg < narg) { - if (strcmp(arg[iarg],"add") == 0) { + if (strcmp(arg[iarg],"virial") == 0) { + if (iarg+2 > narg) error->all(FLERR,"Illegal fix mdi/qm command"); + if (strcmp(arg[iarg],"yes") == 0) virialflag = 1; + else if (strcmp(arg[iarg],"no") == 0) virialflag = 0; + else error->all(FLERR,"Illegal fix mdi/qm command"); + iarg += 2; + } else if (strcmp(arg[iarg],"add") == 0) { if (iarg+2 > narg) error->all(FLERR,"Illegal fix mdi/qm command"); if (strcmp(arg[iarg],"yes") == 0) addflag = 1; else if (strcmp(arg[iarg],"no") == 0) addflag = 0; @@ -66,18 +66,40 @@ FixMDIQM::FixMDIQM(LAMMPS *lmp, int narg, char **arg) : Fix(lmp, narg, arg) } else if (strcmp(arg[iarg],"every") == 0) { if (iarg+2 > narg) error->all(FLERR,"Illegal fix mdi/qm command"); every = utils::inumeric(FLERR,arg[iarg+1],false,lmp); - if (every < 0) error->all(FLERR,"Illegal fix mdi/qm command"); + if (every <= 0) error->all(FLERR,"Illegal fix mdi/qm command"); iarg += 2; } else error->all(FLERR,"Illegal fix mdi/qm command"); } + // fix output settings are based on optional keywords + + scalar_flag = 1; + global_freq = every; + extscalar = 1; + + if (virialflag) { + vector_flag = 1; + size_vector = 6; + extvector = 1; + } + + if (addflag) { + energy_global_flag = 1; + virial_global_flag = 1; + thermo_energy = thermo_virial = 1; + } + // mdicomm will be one-time initialized in init() // cannot be done here for a plugin library, b/c mdi plugin command is later mdicomm = MDI_COMM_NULL; - // storage for all atoms + // peratom storage, both for nlocal and global natoms + fqm = nullptr; + maxlocal = 0; + + ibuf1 = ibuf1all = nullptr; buf3 = buf3all = nullptr; maxbuf = 0; @@ -93,6 +115,17 @@ FixMDIQM::FixMDIQM(LAMMPS *lmp, int narg, char **arg) : Fix(lmp, narg, arg) unit_conversions(); nprocs = comm->nprocs; + + // initialize outputs + + qm_energy = 0.0; + if (virialflag) { + for (int i = 0; i < 6; i++) { + qm_virial[i] = 0.0; + virial[i] = 0.0; + } + sumflag = 0; + } } /* ---------------------------------------------------------------------- */ @@ -109,6 +142,10 @@ FixMDIQM::~FixMDIQM() // clean up + memory->destroy(fqm); + + memory->destroy(ibuf1); + memory->destroy(ibuf1all); memory->destroy(buf3); memory->destroy(buf3all); } @@ -128,26 +165,38 @@ int FixMDIQM::setmask() void FixMDIQM::init() { - if (mdicomm != MDI_COMM_NULL) return; - // one-time auto-detect whether engine is stand-alone code or plugin library // also initializes mdicomm - // plugin = 0/1 for engine = stand-alone code vs plugin library - - MDI_Get_communicator(&mdicomm, 0); + // set plugin = 0/1 for engine = stand-alone code vs plugin library if (mdicomm == MDI_COMM_NULL) { - plugin = 0; - MDI_Accept_communicator(&mdicomm); - if (mdicomm == MDI_COMM_NULL) - error->all(FLERR, "MDI unable to connect to stand-alone engine"); - } else { - plugin = 1; - int method; - MDI_Get_method(&method, mdicomm); - if (method != MDI_PLUGIN) - error->all(FLERR, "MDI internal error for plugin engine"); + MDI_Get_communicator(&mdicomm, 0); + if (mdicomm == MDI_COMM_NULL) { + plugin = 0; + MDI_Accept_communicator(&mdicomm); + if (mdicomm == MDI_COMM_NULL) + error->all(FLERR, "MDI unable to connect to stand-alone engine"); + } else { + plugin = 1; + int method; + MDI_Get_method(&method, mdicomm); + if (method != MDI_PLUGIN) + error->all(FLERR, "MDI internal error for plugin engine"); + } } + + // send natoms, atom types, and simulation box to engine + // this will trigger setup of a new system + // subsequent calls in post_force() will be for same system until new init() + + int ierr = MDI_Send_command(">NATOMS", mdicomm); + if (ierr) error->all(FLERR, "MDI: >NATOMS command"); + int n = static_cast (atom->natoms); + ierr = MDI_Send(&n, 1, MDI_INT, mdicomm); + if (ierr) error->all(FLERR, "MDI: >NATOMS data"); + + send_types(); + send_box(); } /* ---------------------------------------------------------------------- */ @@ -159,59 +208,25 @@ void FixMDIQM::setup(int vflag) /* ---------------------------------------------------------------------- */ -void FixMDIQM::setup_pre_reverse(int eflag, int vflag) -{ - pre_reverse(eflag, vflag); -} - -/* ---------------------------------------------------------------------- - store eflag, so can use it in post_force to request energy -------------------------------------------------------------------------- */ - -void FixMDIQM::pre_reverse(int eflag, int /*vflag*/) -{ - eflag_caller = eflag; -} - -/* ---------------------------------------------------------------------- */ - void FixMDIQM::post_force(int vflag) { - int ilocal, ierr; - double cell[9]; + int index, ierr; - int eflag = eflag_caller; - ev_init(eflag, vflag); + // skip if timestep is not a multiple of every + + if (update->ntimestep % every) return; + + // reallocate peratom storage if necessary, both natoms and nlocal + + reallocate(); // if simulation box dynamically changes, send current box to MDI engine - if (domain->box_change_size || domain->box_change_shape) { - ierr = MDI_Send_command(">CELL_DISPL", mdicomm); - if (ierr) error->all(FLERR, "MDI: >CELL_DISPL command"); - cell[0] = domain->boxlo[0] * lmp2mdi_length; - cell[1] = domain->boxlo[1] * lmp2mdi_length; - cell[2] = domain->boxlo[2] * lmp2mdi_length; - ierr = MDI_Send(cell, 3, MDI_DOUBLE, mdicomm); - if (ierr) error->all(FLERR, "MDI: >CELL_DISPL data"); - - ierr = MDI_Send_command(">CELL", mdicomm); - if (ierr) error->all(FLERR, "MDI: >CELL command"); - cell[0] = domain->boxhi[0] - domain->boxlo[0]; - cell[1] = 0.0; - cell[2] = 0.0; - cell[3] = domain->xy; - cell[4] = domain->boxhi[1] - domain->boxlo[1]; - cell[5] = 0.0; - cell[6] = domain->xz; - cell[7] = domain->yz; - cell[8] = domain->boxhi[2] - domain->boxlo[2]; - ierr = MDI_Send(cell, 9, MDI_DOUBLE, mdicomm); - if (ierr) error->all(FLERR, "MDI: >CELL data"); - } + if (domain->box_change_size || domain->box_change_shape) + send_box(); // gather all coords, ordered by atomID - reallocate(); memset(buf3, 0, 3 * atom->natoms * sizeof(double)); double **x = atom->x; @@ -219,13 +234,14 @@ void FixMDIQM::post_force(int vflag) int nlocal = atom->nlocal; for (int i = 0; i < nlocal; i++) { - ilocal = static_cast(tag[i]) - 1; - buf3[3 * ilocal + 0] = x[i][0] * lmp2mdi_length; - buf3[3 * ilocal + 1] = x[i][1] * lmp2mdi_length; - buf3[3 * ilocal + 2] = x[i][2] * lmp2mdi_length; + index = static_cast(tag[i]) - 1; + buf3[3 * index + 0] = x[i][0] * lmp2mdi_length; + buf3[3 * index + 1] = x[i][1] * lmp2mdi_length; + buf3[3 * index + 2] = x[i][2] * lmp2mdi_length; } - MPI_Reduce(buf3, buf3all, 3 * atom->natoms, MPI_DOUBLE, MPI_SUM, 0, world); + int n = static_cast (atom->natoms); + MPI_Reduce(buf3, buf3all, 3 * n, MPI_DOUBLE, MPI_SUM, 0, world); // send current coords to MDI engine @@ -234,42 +250,54 @@ void FixMDIQM::post_force(int vflag) ierr = MDI_Send(buf3all, 3 * atom->natoms, MDI_DOUBLE, mdicomm); if (ierr) error->all(FLERR, "MDI: >COORDS data"); + // request potential energy from MDI engine + // this triggers engine to perform QM calculation + // qm_energy = fix output for global QM energy + + ierr = MDI_Send_command("all(FLERR, "MDI: all(FLERR, "MDI: all(FLERR, "MDI: natoms, MDI_DOUBLE, mdicomm); if (ierr) error->all(FLERR, "MDI: natoms, MPI_DOUBLE, 0, world); + MPI_Bcast(buf3, 3 * n, MPI_DOUBLE, 0, world); - // add forces to owned atoms - // use atomID to index into ordered buf3 - - double **f = atom->f; + // fqm = fix output for peratom QM forces + // use atomID of local atoms to index into ordered buf3 for (int i = 0; i < nlocal; i++) { - ilocal = static_cast(tag[i]) - 1; - f[i][0] += buf3[3 * ilocal + 0] * mdi2lmp_force; - f[i][1] += buf3[3 * ilocal + 1] * mdi2lmp_force; - f[i][2] += buf3[3 * ilocal + 2] * mdi2lmp_force; + index = static_cast(tag[i]) - 1; + fqm[i][0] = buf3[3 * index + 0] * mdi2lmp_force; + fqm[i][1] = buf3[3 * index + 1] * mdi2lmp_force; + fqm[i][2] = buf3[3 * index + 2] * mdi2lmp_force; } - // optionally request potential energy from MDI engine + // optionally add forces to owned atoms + // use atomID of local atoms to index into ordered buf3 - if (eflag_global) { - ierr = MDI_Send_command("all(FLERR, "MDI: all(FLERR, "MDI: f; + for (int i = 0; i < nlocal; i++) { + index = static_cast(tag[i]) - 1; + f[i][0] += buf3[3 * index + 0] * mdi2lmp_force; + f[i][1] += buf3[3 * index + 1] * mdi2lmp_force; + f[i][2] += buf3[3 * index + 2] * mdi2lmp_force; + } } // optionally request pressure tensor from MDI engine, convert to virial // divide by nprocs so each proc stores a portion + // MPI_Allreduce is performed in compute_vector() + // qm_virial = fix output for global QM virial - if (vflag_global) { + if (virialflag) { double ptensor[6]; ierr = MDI_Send_command("all(FLERR, "MDI: xprd * domain->yprd * domain->zprd; for (int i = 0; i < 6; i++) { ptensor[i] *= mdi2lmp_pressure; - virial[i] = ptensor[i] * volume / force->nktv2p / nprocs; + qm_virial[i] = ptensor[i] * volume / force->nktv2p / nprocs; } + sumflag = 0; + } + + // optionally set fix->virial + + if (virialflag && addflag) { + for (int i = 0; i < 6; i++) + virial[i] = qm_virial[i]; } } @@ -298,27 +334,111 @@ void FixMDIQM::min_post_force(int vflag) double FixMDIQM::compute_scalar() { - return engine_energy; + return qm_energy; } /* ---------------------------------------------------------------------- - reallocate storage for all atoms if necessary + virial from MDI engine +------------------------------------------------------------------------- */ + +double FixMDIQM::compute_vector(int n) +{ + // only sum across procs one time + + if (sumflag == 0) { + MPI_Allreduce(qm_virial, qm_virial_all, 6, MPI_DOUBLE, MPI_SUM, world); + sumflag = 1; + } + + return qm_virial_all[n]; +} + +/* ---------------------------------------------------------------------- + reallocate storage for local and global and atoms if needed ------------------------------------------------------------------------- */ void FixMDIQM::reallocate() { - if (atom->natoms <= maxbuf) return; + if (atom->nlocal > maxlocal) { + maxlocal = atom->nmax; + memory->destroy(fqm); + memory->create(fqm, maxlocal, 3, "mdi:fqm"); + array_atom = fqm; + } - if (3 * atom->natoms > MAXSMALLINT) - error->all(FLERR, "Natoms too large to use with fix mdi/qm"); + if (atom->natoms > maxbuf) { + bigint nsize = atom->natoms * 3; + if (nsize > MAXSMALLINT) + error->all(FLERR, "Natoms too large to use with fix mdi/qm"); + + maxbuf = static_cast (atom->natoms); + memory->destroy(ibuf1); + memory->destroy(buf3); + memory->destroy(buf3all); + memory->create(ibuf1, maxbuf, "mdi:ibuf1"); + memory->create(ibuf1all, maxbuf, "mdi:ibuf1all"); + memory->create(buf3, 3 * maxbuf, "mdi:buf3"); + memory->create(buf3all, 3 * maxbuf, "mdi:buf3all"); + } +} - maxbuf = atom->natoms; +/* ---------------------------------------------------------------------- + send numeric atom types to MDI engine +------------------------------------------------------------------------- */ - memory->destroy(buf3); - memory->destroy(buf3all); +void FixMDIQM::send_types() +{ + memset(ibuf1, 0, atom->natoms * sizeof(int)); - memory->create(buf3, 3 * maxbuf, "mdi:buf3"); - memory->create(buf3all, 3 * maxbuf, "mdi:buf3all"); + // use local atomID to index into ordered ibuf1 + + tagint *tag = atom->tag; + int *type = atom->type; + int nlocal = atom->nlocal; + + int index; + for (int i = 0; i < nlocal; i++) { + index = static_cast(tag[i]) - 1; + ibuf1[index] = type[i]; + } + + int n = static_cast (atom->natoms); + MPI_Reduce(ibuf1, ibuf1all, n, MPI_INT, MPI_SUM, 0, world); + + int ierr = MDI_Send(ibuf1all, n, MDI_INT, mdicomm); + if (ierr) error->all(FLERR, "MDI: >TYPES data"); +} + + +/* ---------------------------------------------------------------------- + send simulation box size and shape to MDI engine +------------------------------------------------------------------------- */ + +void FixMDIQM::send_box() +{ + double cell[9]; + + int ierr = MDI_Send_command(">CELL_DISPL", mdicomm); + if (ierr) error->all(FLERR, "MDI: >CELL_DISPL command"); + cell[0] = domain->boxlo[0] * lmp2mdi_length; + cell[1] = domain->boxlo[1] * lmp2mdi_length; + cell[2] = domain->boxlo[2] * lmp2mdi_length; + ierr = MDI_Send(cell, 3, MDI_DOUBLE, mdicomm); + if (ierr) error->all(FLERR, "MDI: >CELL_DISPL data"); + + ierr = MDI_Send_command(">CELL", mdicomm); + if (ierr) error->all(FLERR, "MDI: >CELL command"); + cell[0] = domain->boxhi[0] - domain->boxlo[0]; + cell[1] = 0.0; + cell[2] = 0.0; + cell[3] = domain->xy; + cell[4] = domain->boxhi[1] - domain->boxlo[1]; + cell[5] = 0.0; + cell[6] = domain->xz; + cell[7] = domain->yz; + cell[8] = domain->boxhi[2] - domain->boxlo[2]; + ierr = MDI_Send(cell, 9, MDI_DOUBLE, mdicomm); + if (ierr) error->all(FLERR, "MDI: >CELL data"); } /* ---------------------------------------------------------------------- @@ -384,17 +504,4 @@ void FixMDIQM::unit_conversions() ev_to_hartree / (angstrom_to_bohr * angstrom_to_bohr * angstrom_to_bohr) / force->nktv2p; mdi2lmp_pressure = 1.0 / lmp2mdi_pressure; } - - // velocity units = distance/time - - mdi2lmp_velocity = 1.0; - lmp2mdi_velocity = 1.0; - - if (lmpunits == REAL) { - lmp2mdi_velocity = angstrom_to_bohr / (1.0e-15 * second_to_aut); - mdi2lmp_velocity = 1.0 / lmp2mdi_velocity; - } else if (lmpunits == METAL) { - lmp2mdi_velocity = angstrom_to_bohr / (1.0e-12 * second_to_aut); - mdi2lmp_velocity = 1.0 / lmp2mdi_velocity; - } } diff --git a/src/MDI/fix_mdi_qm.h b/src/MDI/fix_mdi_qm.h index 88b6a3cd8c..95b4bcbe6d 100644 --- a/src/MDI/fix_mdi_qm.h +++ b/src/MDI/fix_mdi_qm.h @@ -33,22 +33,25 @@ class FixMDIQM : public Fix { void init(); void setup(int); - void setup_pre_reverse(int, int); - void pre_reverse(int, int); void post_force(int); void min_post_force(int); double compute_scalar(); + double compute_vector(int); private: int nprocs; + int virialflag,addflag,every; int plugin; + int maxlocal; + int sumflag; + + double qm_energy; + int lmpunits; + double qm_virial[6],qm_virial_all[6]; + double **fqm; MDI_Comm mdicomm; - int eflag_caller; - double engine_energy; - int lmpunits; - // unit conversion factors double lmp2mdi_length, mdi2lmp_length; @@ -60,11 +63,14 @@ class FixMDIQM : public Fix { // buffers for MDI comm int maxbuf; + int *ibuf1, *ibuf1all; double *buf3, *buf3all; // methods void reallocate(); + void send_types(); + void send_box(); void unit_conversions(); }; diff --git a/src/MDI/mdi_engine.cpp b/src/MDI/mdi_engine.cpp index f2b96cb69a..c5fc7e0b50 100644 --- a/src/MDI/mdi_engine.cpp +++ b/src/MDI/mdi_engine.cpp @@ -135,7 +135,7 @@ MDIEngine::MDIEngine(LAMMPS *_lmp, int narg, char ** /*arg*/) : Pointers(_lmp) ibuf1 = ibuf1all = nullptr; maxatom = 0; - sys_natoms = atom->natoms; + sys_natoms = static_cast (atom->natoms); reallocate(); nsteps = 0; @@ -1239,7 +1239,7 @@ void MDIEngine::receive_velocities() void MDIEngine::receive_double3(int which) { - int n = 3 * atom->natoms; + int n = 3 * sys_natoms; int ierr = MDI_Recv(buf3, n, MDI_DOUBLE, mdicomm); if (ierr) error->all(FLERR, "MDI: natoms * MDI_LABEL_LENGTH]; - memset(labels, ' ', atom->natoms * MDI_LABEL_LENGTH); + auto labels = new char[sys_natoms * MDI_LABEL_LENGTH]; + memset(labels, ' ', sys_natoms * MDI_LABEL_LENGTH); - memset(ibuf1, 0, atom->natoms * sizeof(int)); + memset(ibuf1, 0, sys_natoms * sizeof(int)); // use atomID to index into ordered ibuf1 @@ -1370,17 +1370,17 @@ void MDIEngine::send_labels() ibuf1[ilocal] = type[i]; } - MPI_Reduce(ibuf1, ibuf1all, atom->natoms, MPI_INT, MPI_SUM, 0, world); + MPI_Reduce(ibuf1, ibuf1all, sys_natoms, MPI_INT, MPI_SUM, 0, world); if (comm->me == 0) { - for (int iatom = 0; iatom < atom->natoms; iatom++) { + for (int iatom = 0; iatom < sys_natoms; iatom++) { std::string label = std::to_string(ibuf1all[iatom]); int label_len = std::min(int(label.length()), MDI_LABEL_LENGTH); strncpy(&labels[iatom * MDI_LABEL_LENGTH], label.c_str(), label_len); } } - int ierr = MDI_Send(labels, atom->natoms * MDI_LABEL_LENGTH, MDI_CHAR, mdicomm); + int ierr = MDI_Send(labels, sys_natoms * MDI_LABEL_LENGTH, MDI_CHAR, mdicomm); if (ierr) error->all(FLERR, "MDI: (atom->natoms); - int ierr = MDI_Send(&natoms, 1, MDI_INT, mdicomm); + int ierr = MDI_Send(&sys_natoms, 1, MDI_INT, mdicomm); if (ierr != 0) error->all(FLERR, "MDI: natoms * sizeof(double)); + memset(buf1, 0, sys_natoms * sizeof(double)); // use atomID to index into ordered buf1 @@ -1467,9 +1466,9 @@ void MDIEngine::send_double1(int which) } } - MPI_Reduce(buf1, buf1all, atom->natoms, MPI_DOUBLE, MPI_SUM, 0, world); + MPI_Reduce(buf1, buf1all, sys_natoms, MPI_DOUBLE, MPI_SUM, 0, world); - int ierr = MDI_Send(buf1all, atom->natoms, MDI_DOUBLE, mdicomm); + int ierr = MDI_Send(buf1all, sys_natoms, MDI_DOUBLE, mdicomm); if (ierr) error->all(FLERR, "MDI: natoms * sizeof(int)); + memset(ibuf1, 0, sys_natoms * sizeof(int)); // use atomID to index into ordered ibuf1 @@ -1498,9 +1497,9 @@ void MDIEngine::send_int1(int which) } } - MPI_Reduce(ibuf1, ibuf1all, atom->natoms, MPI_INT, MPI_SUM, 0, world); + MPI_Reduce(ibuf1, ibuf1all, sys_natoms, MPI_INT, MPI_SUM, 0, world); - int ierr = MDI_Send(ibuf1all, atom->natoms, MDI_INT, mdicomm); + int ierr = MDI_Send(ibuf1all, sys_natoms, MDI_INT, mdicomm); if (ierr) error->all(FLERR, "MDI: natoms * sizeof(double)); + memset(buf3, 0, 3 * sys_natoms * sizeof(double)); // use atomID to index into ordered buf3 @@ -1547,9 +1546,9 @@ void MDIEngine::send_double3(int which) } } - MPI_Reduce(buf3, buf3all, 3 * atom->natoms, MPI_DOUBLE, MPI_SUM, 0, world); + MPI_Reduce(buf3, buf3all, 3 * sys_natoms, MPI_DOUBLE, MPI_SUM, 0, world); - int ierr = MDI_Send(buf3all, 3 * atom->natoms, MDI_DOUBLE, mdicomm); + int ierr = MDI_Send(buf3all, 3 * sys_natoms, MDI_DOUBLE, mdicomm); if (ierr) error->all(FLERR, "MDI: MAXSMALLINT) error->all(FLERR, "Natoms too large to use with mdi engine"); + bigint nsize = (bigint) sys_natoms * 3; + if (nsize > MAXSMALLINT) error->all(FLERR, "Natoms too large to use with mdi engine"); maxatom = sys_natoms; diff --git a/src/MDI/mdi_plugin.cpp b/src/MDI/mdi_plugin.cpp index 3c8e38481d..c2add38266 100644 --- a/src/MDI/mdi_plugin.cpp +++ b/src/MDI/mdi_plugin.cpp @@ -19,7 +19,6 @@ #include "mdi_plugin.h" #include "error.h" -#include "fix_mdi_aimd.h" #include "input.h" #include "modify.h" From 215552eb562c2080dae5f6d8aab3049fcfe0fe66 Mon Sep 17 00:00:00 2001 From: Jacob Gissinger Date: Tue, 14 Jun 2022 12:39:03 -0400 Subject: [PATCH 357/585] typo --- src/REAXFF/fix_reaxff_species.cpp | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/src/REAXFF/fix_reaxff_species.cpp b/src/REAXFF/fix_reaxff_species.cpp index 5325086ef9..e5298bdc4d 100644 --- a/src/REAXFF/fix_reaxff_species.cpp +++ b/src/REAXFF/fix_reaxff_species.cpp @@ -219,10 +219,10 @@ FixReaxFFSpecies::FixReaxFFSpecies(LAMMPS *lmp, int narg, char **arg) : Fix(lmp, fprintf(fdel,"\t%s",del_species[i].c_str()); fprintf(fdel,"\n"); fflush(fdel); - } else error->all(FLERR, "Illegal fix reaxff/species command"); + } iarg += ndelspec + 4; - } + } else error->all(FLERR, "Illegal fix reaxff/species command"); // position of molecules } else if (strcmp(arg[iarg], "position") == 0) { From 927287e3e5b1c5d308aed767e615c4dcfa93475a Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 14 Jun 2022 14:06:11 -0400 Subject: [PATCH 358/585] fixes from clang-tidy --- src/ATC/fix_atc.cpp | 2 +- src/KOKKOS/pair_pace_kokkos.cpp | 3 +-- src/MANYBODY/pair_threebody_table.cpp | 12 ++++++------ 3 files changed, 8 insertions(+), 9 deletions(-) diff --git a/src/ATC/fix_atc.cpp b/src/ATC/fix_atc.cpp index a7c0cf5ade..356aa2596c 100644 --- a/src/ATC/fix_atc.cpp +++ b/src/ATC/fix_atc.cpp @@ -284,7 +284,7 @@ FixATC::FixATC(LAMMPS *lmp, int narg, char **arg) : Fix(lmp, narg, arg), int me = ATC::LammpsInterface::instance()->comm_rank(); string groupName(arg[1]); - int igroup = group->find(groupName.c_str()); + int igroup = group->find(groupName); int atomCount = group->count(igroup); try { diff --git a/src/KOKKOS/pair_pace_kokkos.cpp b/src/KOKKOS/pair_pace_kokkos.cpp index 9d78b63167..4ffc971cea 100644 --- a/src/KOKKOS/pair_pace_kokkos.cpp +++ b/src/KOKKOS/pair_pace_kokkos.cpp @@ -534,8 +534,7 @@ void PairPACEKokkos::compute(int eflag_in, int vflag_in) } copymode = 1; - int newton_pair = force->newton_pair; - if (newton_pair == false) + if (!force->newton_pair) error->all(FLERR,"PairPACEKokkos requires 'newton on'"); if (recursive) diff --git a/src/MANYBODY/pair_threebody_table.cpp b/src/MANYBODY/pair_threebody_table.cpp index 14f3c261d9..2f4bc83f5a 100644 --- a/src/MANYBODY/pair_threebody_table.cpp +++ b/src/MANYBODY/pair_threebody_table.cpp @@ -450,7 +450,7 @@ void PairThreebodyTable::read_table(Table *tb, char *file, char *keyword, bool s param_extract(tb, line); // if it is a symmetric threebody interaction, less table entries are required - if (symmetric == true) { + if (symmetric) { memory->create(tb->r12file, tb->ninput * tb->ninput * (tb->ninput + 1), "mltable:r12file"); memory->create(tb->r13file, tb->ninput * tb->ninput * (tb->ninput + 1), "mltable:r13file"); memory->create(tb->thetafile, tb->ninput * tb->ninput * (tb->ninput + 1), "mltable:thetafile"); @@ -481,7 +481,7 @@ void PairThreebodyTable::read_table(Table *tb, char *file, char *keyword, bool s int cerror = 0; reader.skip_line(); // if it is a symmetric threebody interaction, less table entries are required - if (symmetric == true) { + if (symmetric) { for (int i = 0; i < tb->ninput * tb->ninput * (tb->ninput + 1); i++) { line = reader.next_line(11); try { @@ -583,7 +583,7 @@ void PairThreebodyTable::bcast_table(Table *tb, bool symmetric) MPI_Comm_rank(world, &me); if (me > 0) { // if it is a symmetric threebody interaction, less table entries are required - if (symmetric == true) { + if (symmetric) { memory->create(tb->r12file, tb->ninput * tb->ninput * (tb->ninput + 1), "mltable:r12file"); memory->create(tb->r13file, tb->ninput * tb->ninput * (tb->ninput + 1), "mltable:r13file"); memory->create(tb->thetafile, tb->ninput * tb->ninput * (tb->ninput + 1), @@ -612,7 +612,7 @@ void PairThreebodyTable::bcast_table(Table *tb, bool symmetric) } // if it is a symmetric threebody interaction, less table entries are required - if (symmetric == true) { + if (symmetric) { MPI_Bcast(tb->r12file, tb->ninput * tb->ninput * (tb->ninput + 1), MPI_DOUBLE, 0, world); MPI_Bcast(tb->r13file, tb->ninput * tb->ninput * (tb->ninput + 1), MPI_DOUBLE, 0, world); MPI_Bcast(tb->thetafile, tb->ninput * tb->ninput * (tb->ninput + 1), MPI_DOUBLE, 0, world); @@ -697,7 +697,7 @@ void PairThreebodyTable::uf_lookup(Param *pm, double r12, double r13, double the //lookup scheme // if it is a symmetric threebody interaction, less table entries are required - if (pm->symmetric == true) { + if (pm->symmetric) { nr12 = (r12 - pm->mltable->rmin + 0.5 * dr - 0.00000001) / dr; if (r12 == (pm->mltable->rmin - 0.5 * dr)) { nr12 = 0; } nr13 = (r13 - pm->mltable->rmin + 0.5 * dr - 0.00000001) / dr; @@ -778,7 +778,7 @@ void PairThreebodyTable::threebody(Param *paramijk, double rsq1, double rsq2, do } // if the indices have been swapped, swap them back - if (swapped == true) { + if (swapped) { temp = r12; r12 = r13; r13 = temp; From 5060a8b8a5853c2f500012a4c768bcf335c64315 Mon Sep 17 00:00:00 2001 From: rohskopf Date: Tue, 14 Jun 2022 16:31:31 -0600 Subject: [PATCH 359/585] Make dB/dR indices start at zero in compute snap array. --- src/ML-SNAP/compute_snap.cpp | 77 ++++++++++++++++++++++++------------ 1 file changed, 52 insertions(+), 25 deletions(-) diff --git a/src/ML-SNAP/compute_snap.cpp b/src/ML-SNAP/compute_snap.cpp index b40d86546b..3927703f01 100644 --- a/src/ML-SNAP/compute_snap.cpp +++ b/src/ML-SNAP/compute_snap.cpp @@ -220,20 +220,26 @@ ComputeSnap::~ComputeSnap() { memory->destroy(snap); + //printf("---------------- 1\n"); memory->destroy(snapall); + //printf("---------------- 2\n"); memory->destroy(snap_peratom); + //printf("---------------- 3\n"); memory->destroy(radelem); + //printf("---------------- 4\n"); memory->destroy(wjelem); + //printf("---------------- 5\n"); memory->destroy(cutsq); + //printf("---------------- 6\n"); delete snaptr; - + //printf("---------------- 7\n"); if (chemflag) memory->destroy(map); if (switchinnerflag) { memory->destroy(sinnerelem); memory->destroy(dinnerelem); } - + //printf("---------------- 8\n"); if (dbirjflag){ //printf("dbirj_rows: %d\n", dbirj_rows); //printf("----- destroy dbirj\n"); @@ -248,6 +254,7 @@ ComputeSnap::~ComputeSnap() memory->destroy(dbiri); //printf("----- 5-1-1-1-1-1\n"); } + //printf("---------------- 9\n"); } /* ---------------------------------------------------------------------- */ @@ -529,14 +536,14 @@ void ComputeSnap::compute_array() dbirj[dbirj_row_indx+1][icoeff] = snaptr->dblist[icoeff][1]; dbirj[dbirj_row_indx+2][icoeff] = snaptr->dblist[icoeff][2]; if (icoeff==(ncoeff-1)){ - dbirj[dbirj_row_indx+0][ncoeff] = atom->tag[i]; - dbirj[dbirj_row_indx+0][ncoeff+1] = atom->tag[j]; + dbirj[dbirj_row_indx+0][ncoeff] = atom->tag[i]-1; + dbirj[dbirj_row_indx+0][ncoeff+1] = atom->tag[j]-1; dbirj[dbirj_row_indx+0][ncoeff+2] = 0; - dbirj[dbirj_row_indx+1][ncoeff] = atom->tag[i]; - dbirj[dbirj_row_indx+1][ncoeff+1] = atom->tag[j]; + dbirj[dbirj_row_indx+1][ncoeff] = atom->tag[i]-1; + dbirj[dbirj_row_indx+1][ncoeff+1] = atom->tag[j]-1; dbirj[dbirj_row_indx+1][ncoeff+2] = 1; - dbirj[dbirj_row_indx+2][ncoeff] = atom->tag[i]; - dbirj[dbirj_row_indx+2][ncoeff+1] = atom->tag[j]; + dbirj[dbirj_row_indx+2][ncoeff] = atom->tag[i]-1; + dbirj[dbirj_row_indx+2][ncoeff+1] = atom->tag[j]-1; dbirj[dbirj_row_indx+2][ncoeff+2] = 2; } // Accumulate dBi/dRi = sum (-dBi/dRj) for neighbors j of if i. @@ -545,16 +552,16 @@ void ComputeSnap::compute_array() dbiri[3*(atom->tag[i]-1)+2][icoeff] -= snaptr->dblist[icoeff][2]; // Get last columns if (icoeff==(ncoeff-1)){ - dbiri[3*(atom->tag[i]-1)+0][ncoeff] = atom->tag[i]; - dbiri[3*(atom->tag[i]-1)+0][ncoeff+1] = atom->tag[i]; + dbiri[3*(atom->tag[i]-1)+0][ncoeff] = atom->tag[i]-1; + dbiri[3*(atom->tag[i]-1)+0][ncoeff+1] = atom->tag[i]-1; dbiri[3*(atom->tag[i]-1)+0][ncoeff+2] = 0; - dbiri[3*(atom->tag[i]-1)+1][ncoeff] = atom->tag[i]; - dbiri[3*(atom->tag[i]-1)+1][ncoeff+1] = atom->tag[i]; + dbiri[3*(atom->tag[i]-1)+1][ncoeff] = atom->tag[i]-1; + dbiri[3*(atom->tag[i]-1)+1][ncoeff+1] = atom->tag[i]-1; dbiri[3*(atom->tag[i]-1)+1][ncoeff+2] = 1; - dbiri[3*(atom->tag[i]-1)+2][ncoeff] = atom->tag[i]; - dbiri[3*(atom->tag[i]-1)+2][ncoeff+1] = atom->tag[i]; + dbiri[3*(atom->tag[i]-1)+2][ncoeff] = atom->tag[i]-1; + dbiri[3*(atom->tag[i]-1)+2][ncoeff+1] = atom->tag[i]-1; dbiri[3*(atom->tag[i]-1)+2][ncoeff+2] = 2; } } @@ -821,7 +828,15 @@ void ComputeSnap::compute_array() */ // accumulate forces to global array if (dbirjflag){ + for (int i=0; inlocal; i++){ + + int iglobal = atom->tag[i]; + snap[iglobal-1][ncoeff+0] = atom->f[i][0]; + snap[iglobal-1][ncoeff+1] = atom->f[i][1]; + snap[iglobal-1][ncoeff+2] = atom->f[i][2]; + + } } else{ for (int i = 0; i < atom->nlocal; i++) { @@ -838,13 +853,22 @@ void ComputeSnap::compute_array() // accumulate bispectrum virial contributions to global array - //dbdotr_compute(); + if (dbirjflag){ + + } + else{ + dbdotr_compute(); + } // sum up over all processes MPI_Allreduce(&snap[0][0],&snapall[0][0],size_array_rows*size_array_cols,MPI_DOUBLE,MPI_SUM,world); // assign energy to last column if (dbirjflag){ - + // Assign reference energy right after the dbirj rows, first column. + int irow = bik_rows + dbirj_rows + 3*natoms; // add 3N for the dBi/dRi rows + //printf("irow bik_rows dbirj_rows: %d %d %d\n", irow, bik_rows, dbirj_rows); + double reference_energy = c_pe->compute_scalar(); + snapall[irow][0] = reference_energy; } else{ for (int i = 0; i < bik_rows; i++) snapall[i][lastcol] = 0; @@ -857,15 +881,18 @@ void ComputeSnap::compute_array() // switch to Voigt notation c_virial->compute_vector(); - /* - irow += 3*natoms+bik_rows; - snapall[irow++][lastcol] = c_virial->vector[0]; - snapall[irow++][lastcol] = c_virial->vector[1]; - snapall[irow++][lastcol] = c_virial->vector[2]; - snapall[irow++][lastcol] = c_virial->vector[5]; - snapall[irow++][lastcol] = c_virial->vector[4]; - snapall[irow][lastcol] = c_virial->vector[3]; - */ + if (dbirjflag){ + + } + else{ + int irow = 3*natoms+bik_rows; + snapall[irow++][lastcol] = c_virial->vector[0]; + snapall[irow++][lastcol] = c_virial->vector[1]; + snapall[irow++][lastcol] = c_virial->vector[2]; + snapall[irow++][lastcol] = c_virial->vector[5]; + snapall[irow++][lastcol] = c_virial->vector[4]; + snapall[irow][lastcol] = c_virial->vector[3]; + } //}// else } From 728e4a59107dac5f9a8865ce4c8259b3cb6e5aee Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 14 Jun 2022 18:51:40 -0400 Subject: [PATCH 360/585] add permissions for codeql action --- .github/workflows/codeql-analysis.yml | 5 +++++ 1 file changed, 5 insertions(+) diff --git a/.github/workflows/codeql-analysis.yml b/.github/workflows/codeql-analysis.yml index 7ea31fcf14..ef1cb0a987 100644 --- a/.github/workflows/codeql-analysis.yml +++ b/.github/workflows/codeql-analysis.yml @@ -13,6 +13,11 @@ jobs: if: ${{ github.repository == 'lammps/lammps' }} runs-on: ubuntu-latest + permissions: + security-events: write + actions: read + contents: read + strategy: fail-fast: false matrix: From 03c0b4ae2718cb80d122936f64bae85112a202bb Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 14 Jun 2022 18:54:32 -0400 Subject: [PATCH 361/585] upgrade action versions --- .github/workflows/codeql-analysis.yml | 6 +++--- .github/workflows/compile-msvc.yml | 4 ++-- .github/workflows/unittest-macos.yml | 2 +- 3 files changed, 6 insertions(+), 6 deletions(-) diff --git a/.github/workflows/codeql-analysis.yml b/.github/workflows/codeql-analysis.yml index ef1cb0a987..07b64296a7 100644 --- a/.github/workflows/codeql-analysis.yml +++ b/.github/workflows/codeql-analysis.yml @@ -25,7 +25,7 @@ jobs: steps: - name: Checkout repository - uses: actions/checkout@v2 + uses: actions/checkout@v3 with: fetch-depth: 2 @@ -35,7 +35,7 @@ jobs: python-version: '3.x' - name: Initialize CodeQL - uses: github/codeql-action/init@v1 + uses: github/codeql-action/init@v2 with: languages: ${{ matrix.language }} config-file: ./.github/codeql/${{ matrix.language }}.yml @@ -53,4 +53,4 @@ jobs: cmake --build . --parallel 2 - name: Perform CodeQL Analysis - uses: github/codeql-action/analyze@v1 + uses: github/codeql-action/analyze@v2 diff --git a/.github/workflows/compile-msvc.yml b/.github/workflows/compile-msvc.yml index 15fcf1099d..7747be7b46 100644 --- a/.github/workflows/compile-msvc.yml +++ b/.github/workflows/compile-msvc.yml @@ -15,12 +15,12 @@ jobs: steps: - name: Checkout repository - uses: actions/checkout@v2 + uses: actions/checkout@v3 with: fetch-depth: 2 - name: Select Python version - uses: actions/setup-python@v2 + uses: actions/setup-python@v4 with: python-version: '3.10' diff --git a/.github/workflows/unittest-macos.yml b/.github/workflows/unittest-macos.yml index 2d903af646..9b8e79425c 100644 --- a/.github/workflows/unittest-macos.yml +++ b/.github/workflows/unittest-macos.yml @@ -17,7 +17,7 @@ jobs: steps: - name: Checkout repository - uses: actions/checkout@v2 + uses: actions/checkout@v3 with: fetch-depth: 2 From a5745d925a2b1cf44e89815ee6dca4ea7be2e7c8 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Tue, 14 Jun 2022 17:29:01 -0600 Subject: [PATCH 362/585] new examples and debugging code changes --- examples/mdi/README | 148 ++++++++++++++++-- examples/mdi/in.aimd.driver | 3 +- examples/mdi/in.aimd.driver.plugin | 5 +- examples/mdi/in.aimd.engine | 9 +- .../mdi/{in.sequence => in.sequence.python} | 0 examples/mdi/in.series.alone | 43 +++++ examples/mdi/in.series.driver | 48 ++++++ examples/mdi/in.series.driver.plugin | 44 ++++++ examples/mdi/in.series.engine | 17 ++ examples/mdi/in.snapshot.alone | 36 +++++ examples/mdi/in.snapshot.driver | 41 +++++ examples/mdi/in.snapshot.driver.plugin | 46 ++++++ examples/mdi/in.snapshot.engine | 17 ++ examples/mdi/sequence_driver.py | 2 +- src/MDI/fix_mdi_qm.cpp | 69 ++++---- src/MDI/fix_mdi_qm.h | 2 +- src/MDI/mdi_command.cpp | 22 ++- src/lammps.cpp | 24 ++- src/lammps.h | 12 +- 19 files changed, 507 insertions(+), 81 deletions(-) rename examples/mdi/{in.sequence => in.sequence.python} (100%) create mode 100644 examples/mdi/in.series.alone create mode 100644 examples/mdi/in.series.driver create mode 100644 examples/mdi/in.series.driver.plugin create mode 100644 examples/mdi/in.series.engine create mode 100644 examples/mdi/in.snapshot.alone create mode 100644 examples/mdi/in.snapshot.driver create mode 100644 examples/mdi/in.snapshot.driver.plugin create mode 100644 examples/mdi/in.snapshot.engine diff --git a/examples/mdi/README b/examples/mdi/README index fd459e6670..9298e9c59c 100644 --- a/examples/mdi/README +++ b/examples/mdi/README @@ -50,7 +50,7 @@ changed in the in.aimd.engine or in.aimd.engine.plugin scripts. Run the entire calculation with a single instance of LAMMPS by itself results should be identical to running this example with MDI -% lmp_mpi < in.aimd.alone +% lmp_mpi -log log.aimd.alone < in.aimd.alone With MDI, the thermo output of the driver should match the thermo output of the in.aimd.alone script. @@ -59,41 +59,157 @@ output of the in.aimd.alone script. Run with TCP: 1 proc each -% lmp_mpi -mdi "-name aimd -role DRIVER -method TCP -port 8021" -log log.aimd.driver -in in.aimd.driver +% lmp_mpi -mdi "-name LMP1 -role DRIVER -method TCP -port 8021" -log log.aimd.driver.tcp -in in.aimd.driver -% lmp_mpi -mdi "-name LAMMPS -role ENGINE -method TCP -port 8021 -hostname localhost" -log log.aimd.engine -in in.aimd.engine +% lmp_mpi -mdi "-name LMP2 -role ENGINE -method TCP -port 8021 -hostname localhost" -log log.aimd.engine.tcp -in in.aimd.engine --- Run with TCP: 3 procs + 4 procs -% mpirun -np 3 lmp_mpi -mdi "-name aimd -role DRIVER -method TCP -port 8021" -log log.aimd.driver -in in.aimd.driver +% mpirun -np 3 lmp_mpi -mdi "-name LMP1 -role DRIVER -method TCP -port 8021" -log log.aimd.driver.tcp -in in.aimd.driver -% mpirun -np 4 lmp_mpi -mdi "-name LAMMPS -role ENGINE -method TCP -port 8021 -hostname localhost" -log log.aimd.engine -in in.aimd.engine +% mpirun -np 4 lmp_mpi -mdi "-name LMP2 -role ENGINE -method TCP -port 8021 -hostname localhost" -log log.aimd.engine.tcp -in in.aimd.engine --- Run with MPI: 1 proc each -% mpirun -np 1 lmp_mpi -mdi "-name aimd -role DRIVER -method MPI" -log log.aimd.driver -in in.aimd.driver : -np 1 lmp_mpi -mdi "-name LAMMPS -role ENGINE -method MPI" -log log.aimd.engine -in in.aimd.engine +% mpirun -np 1 lmp_mpi -mdi "-name LMP1 -role DRIVER -method MPI" -log log.aimd.driver.mpi -in in.aimd.driver : -np 1 lmp_mpi -mdi "-name LMP2 -role ENGINE -method MPI" -log log.aimd.engine.mpi -in in.aimd.engine --- Run with MPI: 3 procs + 4 procs -% mpirun -np 3 lmp_mpi -mdi "-name aimd -role DRIVER -method MPI" -log log.aimd.driver -in in.aimd.driver : -np 4 lmp_mpi -mdi "-name LAMMPS -role ENGINE -method MPI" -log log.aimd.engine -in in.aimd.engine +% mpirun -np 3 lmp_mpi -mdi "-name LMP1 -role DRIVER -method MPI" -log log.aimd.driver.mpi -in in.aimd.driver : -np 4 lmp_mpi -mdi "-name LMP2 -role ENGINE -method MPI" -log log.aimd.engine.mpi -in in.aimd.engine --- Run in plugin mode: 1 proc -% lmp_mpi -mdi "-name aimd -role DRIVER -method LINK -plugin_path /home/sjplimp/lammps/git/src" -log log.aimd.driver.plugin -in in.aimd.driver.plugin +% lmp_mpi -mdi "-name LMP1 -role DRIVER -method LINK -plugin_path /home/sjplimp/lammps/git/src" -log log.aimd.driver.plugin -in in.aimd.driver.plugin --- Run in plugin mode: 3 procs -% mpirun -np 3 lmp_mpi -mdi "-name aimd -role DRIVER -method LINK -plugin_path /home/sjplimp/lammps/git/src" -log log.aimd.driver.plugin -in in.aimd.driver.plugin +% mpirun -np 3 lmp_mpi -mdi "-name LMP1 -role DRIVER -method LINK -plugin_path /home/sjplimp/lammps/git/src" -log log.aimd.driver.plugin -in in.aimd.driver.plugin + +------------------------------------------------- +------------------------------------------------- + +* Example #1b = run LAMMPS, compute QM forces on snapshots from a long run + Two instances of LAMMPS operate as a driver and engine + As an engine, LAMMPS is a surrogate for a quantum code + +--- + +Run the entire calculation with a single instance of LAMMPS by itself + results should be identical to running this example with MDI + +% lmp_mpi -log log.snapshot.alone < in.snapshot.alone + +With MDI, the thermo output of the driver should match the thermo +output of the in.snapshot.alone script. Likewise the dump file written +by the driver should match dump.snapshot.alone. + +--- + +Run with TCP: 1 proc each + +% lmp_mpi -mdi "-name LMP1 -role DRIVER -method TCP -port 8021" -log log.snapshot.driver.tcp -in in.snapshot.driver + +% lmp_mpi -mdi "-name LMP2 -role ENGINE -method TCP -port 8021 -hostname localhost" -log log.snapshot.engine.tcp -in in.snapshot.engine + +--- + +Run with TCP: 3 procs + 4 procs + +% mpirun -np 3 lmp_mpi -mdi "-name LMP1 -role DRIVER -method TCP -port 8021" -log log.snapshot.driver.tcp -in in.snapshot.driver + +% mpirun -np 4 lmp_mpi -mdi "-name LMP2 -role ENGINE -method TCP -port 8021 -hostname localhost" -log log.snapshot.engine.tcp -in in.snapshot.engine + +--- + +Run with MPI: 1 proc each + +% mpirun -np 1 lmp_mpi -mdi "-name LMP1 -role DRIVER -method MPI" -log log.snapshot.driver.mpi -in in.snapshot.driver : -np 1 lmp_mpi -mdi "-name LMP2 -role ENGINE -method MPI" -log log.snapshot.engine.mpi -in in.snapshot.engine + +--- + +Run with MPI: 3 procs + 4 procs + +% mpirun -np 3 lmp_mpi -mdi "-name LMP1 -role DRIVER -method MPI" -log log.snapshot.driver.mpi -in in.snapshot.driver : -np 4 lmp_mpi -mdi "-name LMP2 -role ENGINE -method MPI" -log log.snapshot.engine.mpi -in in.snapshot.engine + +--- + +Run in plugin mode: 1 proc + +% lmp_mpi -mdi "-name LMP1 -role DRIVER -method LINK -plugin_path /home/sjplimp/lammps/git/src" -log log.snapshot.driver.plugin -in in.snapshot.driver.plugin + +--- + +Run in plugin mode: 3 procs + +% mpirun -np 3 lmp_mpi -mdi "-name LMP1 -role DRIVER -method LINK -plugin_path /home/sjplimp/lammps/git/src" -log log.snapshot.driver.plugin -in in.snapshot.driver.plugin + +------------------------------------------------- +------------------------------------------------- + +* Example #1c = run LAMMPS, compute QM forces on series of independent systems + Two instances of LAMMPS operate as a driver and engine + As an engine, LAMMPS is a surrogate for a quantum code + +--- + +Run the entire calculation with a single instance of LAMMPS by itself + results should be identical to running this example with MDI + +% lmp_mpi -log log.series.alone < in.series.alone + +With MDI, the thermo output of the driver should match the thermo +output of the in.series.alone script. Likewise the dump files written +by the driver should match dump.series.alone files. + +--- + +Run with TCP: 1 proc each + +% lmp_mpi -mdi "-name LMP1 -role DRIVER -method TCP -port 8021" -log log.series.driver.tcp -in in.series.driver + +% lmp_mpi -mdi "-name LMP2 -role ENGINE -method TCP -port 8021 -hostname localhost" -log log.series.engine.tcp -in in.series.engine + +--- + +Run with TCP: 3 procs + 4 procs + +% mpirun -np 3 lmp_mpi -mdi "-name LMP1 -role DRIVER -method TCP -port 8021" -log log.series.driver.tcp -in in.series.driver + +% mpirun -np 4 lmp_mpi -mdi "-name LMP2 -role ENGINE -method TCP -port 8021 -hostname localhost" -log log.series.engine.tcp -in in.series.engine + +--- + +Run with MPI: 1 proc each + +% mpirun -np 1 lmp_mpi -mdi "-name LMP1 -role DRIVER -method MPI" -log log.series.driver.mpi -in in.series.driver : -np 1 lmp_mpi -mdi "-name LMP2 -role ENGINE -method MPI" -log log.series.engine.mpi -in in.series.engine + +--- + +Run with MPI: 3 procs + 4 procs + +% mpirun -np 3 lmp_mpi -mdi "-name LMP1 -role DRIVER -method MPI" -log log.series.driver.mpi -in in.series.driver : -np 4 lmp_mpi -mdi "-name LMP2 -role ENGINE -method MPI" -log log.series.engine.mpi -in in.series.engine + +--- + +Run in plugin mode: 1 proc + +% lmp_mpi -mdi "-name LMP1 -role DRIVER -method LINK -plugin_path /home/sjplimp/lammps/git/src" -log log.series.driver.plugin -in in.series.driver.plugin + +--- + +Run in plugin mode: 3 procs + +% mpirun -np 3 lmp_mpi -mdi "-name LMP1 -role DRIVER -method LINK -plugin_path /home/sjplimp/lammps/git/src" -log log.series.driver.plugin -in in.series.driver.plugin ------------------------------------------------- ------------------------------------------------- @@ -134,7 +250,7 @@ Run with TCP: 1 proc each % python3 sequence_driver.py -mdi "-role DRIVER -name sequence -method TCP -port 8021" -% lmp_mpi -mdi "-role ENGINE -name LAMMPS -method TCP -port 8021 -hostname localhost" -log log.sequence -in in.sequence +% lmp_mpi -mdi "-role ENGINE -name LMP -method TCP -port 8021 -hostname localhost" -log log.sequence -in in.sequence.python --- @@ -142,31 +258,31 @@ Run with TCP: 2 proc + 4 procs % mpirun -np 2 python3 sequence_driver.py -mdi "-role DRIVER -name sequence -method TCP -port 8021" -% mpirun -np 4 lmp_mpi -mdi "-role ENGINE -name LAMMPS -method TCP -port 8021 -hostname localhost" -log log.sequence -in in.sequence +% mpirun -np 4 lmp_mpi -mdi "-role ENGINE -name LMP -method TCP -port 8021 -hostname localhost" -log log.sequence -in in.sequence.python --- Run with MPI: 1 proc each -% mpirun -np 1 python3 sequence_driver.py -mdi "-role DRIVER -name sequence -method MPI" : -np 1 lmp_mpi -mdi "-role ENGINE -name LAMMPS -method MPI" -log log.sequence -in in.sequence +% mpirun -np 1 python3 sequence_driver.py -mdi "-role DRIVER -name sequence -method MPI" : -np 1 lmp_mpi -mdi "-role ENGINE -name LAMMPS -method MPI" -log log.sequence -in in.sequence.python --- Run with MPI: 2 procs + 4 procs -% mpirun -np 2 python3 sequence_driver.py -mdi "-role DRIVER -name sequence -method MPI" : -np 4 lmp_mpi -mdi "-role ENGINE -name LAMMPS -method MPI" -log log.sequence -in in.sequence +% mpirun -np 2 python3 sequence_driver.py -mdi "-role DRIVER -name sequence -method MPI" : -np 4 lmp_mpi -mdi "-role ENGINE -name LMP -method MPI" -log log.sequence -in in.sequence.python --- Run in plugin mode: 1 proc -% python3 sequence_driver.py -plugin lammps -mdi "-role DRIVER -name sequence -method LINK -plugin_path /home/sjplimp/lammps/git/src" -plugin_args "-log log.sequence -in in.sequence" +% python3 sequence_driver.py -plugin lammps -mdi "-role DRIVER -name sequence -method LINK -plugin_path /home/sjplimp/lammps/git/src" -plugin_args "-log log.sequence -in in.sequence".python --- Run in plugin mode: 3 procs -% mpirun -np 3 python3 sequence_driver.py -plugin lammps -mdi "-role DRIVER -name sequence -method LINK -plugin_path /home/sjplimp/lammps/git/src" -plugin_args "-log log.sequence -in in.sequence" +% mpirun -np 3 python3 sequence_driver.py -plugin lammps -mdi "-role DRIVER -name sequence -method LINK -plugin_path /home/sjplimp/lammps/git/src" -plugin_args "-log log.sequence -in in.sequence".python ------------------------------------------------- ------------------------------------------------- @@ -190,7 +306,7 @@ here: Run the entire calculation with a single instance of LAMMPS by itself results should be identical to running this example with MDI -% lmp_mpi < in.aimd.alone +% lmp_mpi -log log.aimd.alone < in.aimd.alone With MDI, the driver prints the QM and Total energies. These should match the PotEng and TotEng output of the in.aimd.alone script. diff --git a/examples/mdi/in.aimd.driver b/examples/mdi/in.aimd.driver index 5ee23ebe8d..b21826d831 100644 --- a/examples/mdi/in.aimd.driver +++ b/examples/mdi/in.aimd.driver @@ -23,8 +23,7 @@ fix 1 all nve # NPT #fix 1 all npt temp 1.0 1.0 0.1 iso 1.0 1.0 1.0 -fix 2 all mdi/aimd -fix_modify 2 energy yes virial yes +fix 2 all mdi/qm virial yes thermo_style custom step temp pe etotal press vol thermo 1 diff --git a/examples/mdi/in.aimd.driver.plugin b/examples/mdi/in.aimd.driver.plugin index d8c7fdde62..97514cbcd2 100644 --- a/examples/mdi/in.aimd.driver.plugin +++ b/examples/mdi/in.aimd.driver.plugin @@ -23,12 +23,11 @@ fix 1 all nve # NPT #fix 1 all npt temp 1.0 1.0 0.1 iso 1.0 1.0 1.0 -fix 2 all mdi/aimd -fix_modify 2 energy yes virial yes +fix 2 all mdi/qm virial yes thermo_style custom step temp pe etotal press vol thermo 1 -mdi plugin lammps mdi "-role ENGINE -name lammps -method LINK" & +mdi plugin lammps mdi "-role ENGINE -name LMP2 -method LINK" & infile in.aimd.engine extra "-log log.aimd.engine.plugin" & command "run 5" diff --git a/examples/mdi/in.aimd.engine b/examples/mdi/in.aimd.engine index 11d22c750e..f3293e048d 100644 --- a/examples/mdi/in.aimd.engine +++ b/examples/mdi/in.aimd.engine @@ -1,16 +1,11 @@ # 3d Lennard-Jones melt - MDI engine script -variable x index 5 -variable y index 5 -variable z index 5 - units lj atom_style atomic -lattice fcc 0.8442 -region box block 0 $x 0 $y 0 $z +lattice fcc 1.0 +region box block 0 1 0 1 0 1 create_box 1 box -create_atoms 1 box mass 1 1.0 pair_style lj/cut 2.5 diff --git a/examples/mdi/in.sequence b/examples/mdi/in.sequence.python similarity index 100% rename from examples/mdi/in.sequence rename to examples/mdi/in.sequence.python diff --git a/examples/mdi/in.series.alone b/examples/mdi/in.series.alone new file mode 100644 index 0000000000..d08b72d386 --- /dev/null +++ b/examples/mdi/in.series.alone @@ -0,0 +1,43 @@ +# 3d Lennard-Jones melt - MDI driver script + +variable x index 5 +variable y index 5 +variable z index 5 + +variable ifile loop 3 +variable rho index 0.7 0.8 0.9 + +label LOOP + + units lj + atom_style atomic + + lattice fcc ${rho} + region box block 0 $x 0 $y 0 $z + create_box 1 box + create_atoms 1 box + mass 1 1.0 + + displace_atoms all random 0.1 0.1 0.1 48294 + + pair_style lj/cut 2.5 + pair_coeff 1 1 1.0 1.0 2.5 + + neighbor 0.3 bin + neigh_modify delay 0 every 1 check yes + + compute 1 all pressure NULL virial + + thermo_style custom step temp pe c_1 c_1[1] c_1[2] c_1[3] + + run 0 + + write_dump all custom dump.series.alone.${ifile} & + id type x y z fx fy fz modify sort id + + clear + +next ifile +next rho + +jump SELF LOOP diff --git a/examples/mdi/in.series.driver b/examples/mdi/in.series.driver new file mode 100644 index 0000000000..d8b4df1f8c --- /dev/null +++ b/examples/mdi/in.series.driver @@ -0,0 +1,48 @@ +# 3d Lennard-Jones melt - MDI driver script + +variable x index 5 +variable y index 5 +variable z index 5 + +variable ifile loop 3 +variable rho index 0.7 0.8 0.9 + +mdi start + +label LOOP + + units lj + atom_style atomic + + lattice fcc ${rho} + region box block 0 $x 0 $y 0 $z + create_box 1 box + create_atoms 1 box + mass 1 1.0 + + displace_atoms all random 0.1 0.1 0.1 48294 + + neighbor 0.3 bin + neigh_modify delay 0 every 1 check yes + + fix 1 all mdi/qm add no virial yes external yes + variable epress equal (f_1[1]+f_1[2]+f_1[3])/3 + + thermo_style custom step temp f_1 v_epress f_1[1] f_1[2] f_1[3] + + run 0 + + write_dump all custom dump.series.driver.${ifile} & + id type x y z f_1[1] f_1[2] f_1[3] modify sort id + + # cannot do "clear" b/c will shutdown MDI engine + # have to + + clear + +next ifile +next rho + +jump SELF LOOP + +mdi stop diff --git a/examples/mdi/in.series.driver.plugin b/examples/mdi/in.series.driver.plugin new file mode 100644 index 0000000000..4a4364c447 --- /dev/null +++ b/examples/mdi/in.series.driver.plugin @@ -0,0 +1,44 @@ +# 3d Lennard-Jones melt - MDI driver script + +variable x index 5 +variable y index 5 +variable z index 5 + +variable ifile loop 3 +variable rho index 0.7 0.8 0.9 + +label LOOP + + units lj + atom_style atomic + + lattice fcc ${rho} + region box block 0 $x 0 $y 0 $z + create_box 1 box + create_atoms 1 box + mass 1 1.0 + + displace_atoms all random 0.1 0.1 0.1 48294 + + neighbor 0.3 bin + neigh_modify delay 0 every 1 check yes + + fix 1 all mdi/qm add no virial yes + variable epress equal (f_1[1]+f_1[2]+f_1[3])/3 + + thermo_style custom step temp f_1 v_epress f_1[1] f_1[2] f_1[3] + + mdi plugin lammps mdi "-role ENGINE -name LMP2 -method LINK" & + infile in.series.engine & + extra "-log log.series.engine.plugin" & + command "run 0" + + write_dump all custom dump.series.driver.${ifile} & + id type x y z f_1[1] f_1[2] f_1[3] modify sort id + + clear + +next ifile +next rho + +jump SELF LOOP diff --git a/examples/mdi/in.series.engine b/examples/mdi/in.series.engine new file mode 100644 index 0000000000..f3293e048d --- /dev/null +++ b/examples/mdi/in.series.engine @@ -0,0 +1,17 @@ +# 3d Lennard-Jones melt - MDI engine script + +units lj +atom_style atomic + +lattice fcc 1.0 +region box block 0 1 0 1 0 1 +create_box 1 box +mass 1 1.0 + +pair_style lj/cut 2.5 +pair_coeff 1 1 1.0 1.0 2.5 + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +mdi engine diff --git a/examples/mdi/in.snapshot.alone b/examples/mdi/in.snapshot.alone new file mode 100644 index 0000000000..cf9683be3f --- /dev/null +++ b/examples/mdi/in.snapshot.alone @@ -0,0 +1,36 @@ +# 3d Lennard-Jones melt - MDI driver script + +variable x index 5 +variable y index 5 +variable z index 5 + +units lj +atom_style atomic + +lattice fcc 0.8442 +region box block 0 $x 0 $y 0 $z +create_box 1 box +create_atoms 1 box +mass 1 1.0 + +velocity all create 1.44 87287 loop geom + +pair_style lj/cut 2.5 +pair_coeff 1 1 1.0 1.0 2.5 + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +fix 1 all nve + +compute 1 all pressure NULL virial + +thermo_style custom step temp pe c_1 c_1[1] c_1[2] c_1[3] + +thermo 100 + +dump 1 all custom 500 dump.snapshot.alone & + id type x y z fx fy fz +dump_modify 1 sort id + +run 1500 diff --git a/examples/mdi/in.snapshot.driver b/examples/mdi/in.snapshot.driver new file mode 100644 index 0000000000..607a52a456 --- /dev/null +++ b/examples/mdi/in.snapshot.driver @@ -0,0 +1,41 @@ +# 3d Lennard-Jones melt - MDI driver script + +variable x index 5 +variable y index 5 +variable z index 5 + +units lj +atom_style atomic + +lattice fcc 0.8442 +region box block 0 $x 0 $y 0 $z +create_box 1 box +create_atoms 1 box +mass 1 1.0 + +velocity all create 1.44 87287 loop geom + +pair_style lj/cut 2.5 +pair_coeff 1 1 1.0 1.0 2.5 + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +fix 1 all nve + +fix 2 all mdi/qm add no every 500 virial yes + +compute 1 all pressure NULL virial +variable epress equal (f_2[1]+f_2[2]+f_2[3])/3 + +thermo_style custom step temp pe c_1 c_1[1] c_1[2] c_1[3] + +thermo 100 + +dump 1 all custom 500 dump.snapshot.driver & + id type x y z f_2[1] f_2[2] f_2[3] +dump_modify 1 sort id + +run 1500 pre no post no every 500 & + "print 'QM eng = $(f_2/atoms)'" & + "print 'QM virial = $(v_epress) $(f_2[1]) $(f_2[2]) $(f_2[3])'" diff --git a/examples/mdi/in.snapshot.driver.plugin b/examples/mdi/in.snapshot.driver.plugin new file mode 100644 index 0000000000..7592c5fb59 --- /dev/null +++ b/examples/mdi/in.snapshot.driver.plugin @@ -0,0 +1,46 @@ +# 3d Lennard-Jones melt - MDI driver script + +variable x index 5 +variable y index 5 +variable z index 5 + +units lj +atom_style atomic + +lattice fcc 0.8442 +region box block 0 $x 0 $y 0 $z +create_box 1 box +create_atoms 1 box +mass 1 1.0 + +velocity all create 1.44 87287 loop geom + +pair_style lj/cut 2.5 +pair_coeff 1 1 1.0 1.0 2.5 + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +fix 1 all nve + +fix 2 all mdi/qm add no every 500 virial yes + +compute 1 all pressure NULL virial +variable epress equal (f_2[1]+f_2[2]+f_2[3])/3 + +thermo_style custom step temp pe c_1 c_1[1] c_1[2] c_1[3] + +thermo 100 + +dump 1 all custom 500 dump.snapshot.driver & + id type x y z f_2[1] f_2[2] f_2[3] +dump_modify 1 sort id + +mdi plugin lammps mdi "-role ENGINE -name LMP2 -method LINK" & + infile in.snapshot.engine & + extra "-log log.snapshot.engine.plugin" & + command """ + run 1500 pre no post no every 500 + "print 'QM eng = $(f_2/atoms)'" + "print 'QM virial = $(v_epress) $(f_2[1]) $(f_2[2]) $(f_2[3])'" + """ diff --git a/examples/mdi/in.snapshot.engine b/examples/mdi/in.snapshot.engine new file mode 100644 index 0000000000..f3293e048d --- /dev/null +++ b/examples/mdi/in.snapshot.engine @@ -0,0 +1,17 @@ +# 3d Lennard-Jones melt - MDI engine script + +units lj +atom_style atomic + +lattice fcc 1.0 +region box block 0 1 0 1 0 1 +create_box 1 box +mass 1 1.0 + +pair_style lj/cut 2.5 +pair_coeff 1 1 1.0 1.0 2.5 + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +mdi engine diff --git a/examples/mdi/sequence_driver.py b/examples/mdi/sequence_driver.py index f15b2d4921..b0b26f6d7f 100644 --- a/examples/mdi/sequence_driver.py +++ b/examples/mdi/sequence_driver.py @@ -303,5 +303,5 @@ if not plugin: if plugin: world = MPI.COMM_WORLD - plugin_args += " -mdi \"-role ENGINE -name lammps -method LINK\"" + plugin_args += " -mdi \"-role ENGINE -name LMP -method LINK\"" mdi.MDI_Launch_plugin(plugin,plugin_args,world,perform_tasks,None) diff --git a/src/MDI/fix_mdi_qm.cpp b/src/MDI/fix_mdi_qm.cpp index 7ef03f0e7a..9a6e415a8c 100644 --- a/src/MDI/fix_mdi_qm.cpp +++ b/src/MDI/fix_mdi_qm.cpp @@ -48,19 +48,20 @@ FixMDIQM::FixMDIQM(LAMMPS *lmp, int narg, char **arg) : Fix(lmp, narg, arg) virialflag = 0; addflag = 1; every = 1; + extflag = 0; int iarg = 3; while (iarg < narg) { if (strcmp(arg[iarg],"virial") == 0) { if (iarg+2 > narg) error->all(FLERR,"Illegal fix mdi/qm command"); - if (strcmp(arg[iarg],"yes") == 0) virialflag = 1; - else if (strcmp(arg[iarg],"no") == 0) virialflag = 0; + if (strcmp(arg[iarg+1],"yes") == 0) virialflag = 1; + else if (strcmp(arg[iarg+1],"no") == 0) virialflag = 0; else error->all(FLERR,"Illegal fix mdi/qm command"); iarg += 2; } else if (strcmp(arg[iarg],"add") == 0) { if (iarg+2 > narg) error->all(FLERR,"Illegal fix mdi/qm command"); - if (strcmp(arg[iarg],"yes") == 0) addflag = 1; - else if (strcmp(arg[iarg],"no") == 0) addflag = 0; + if (strcmp(arg[iarg+1],"yes") == 0) addflag = 1; + else if (strcmp(arg[iarg+1],"no") == 0) addflag = 0; else error->all(FLERR,"Illegal fix mdi/qm command"); iarg += 2; } else if (strcmp(arg[iarg],"every") == 0) { @@ -68,6 +69,12 @@ FixMDIQM::FixMDIQM(LAMMPS *lmp, int narg, char **arg) : Fix(lmp, narg, arg) every = utils::inumeric(FLERR,arg[iarg+1],false,lmp); if (every <= 0) error->all(FLERR,"Illegal fix mdi/qm command"); iarg += 2; + } else if (strcmp(arg[iarg],"external") == 0) { + if (iarg+2 > narg) error->all(FLERR,"Illegal fix mdi/qm command"); + if (strcmp(arg[iarg+1],"yes") == 0) extflag = 1; + else if (strcmp(arg[iarg+1],"no") == 0) extflag = 0; + else error->all(FLERR,"Illegal fix mdi/qm command"); + iarg += 2; } else error->all(FLERR,"Illegal fix mdi/qm command"); } @@ -77,10 +84,14 @@ FixMDIQM::FixMDIQM(LAMMPS *lmp, int narg, char **arg) : Fix(lmp, narg, arg) global_freq = every; extscalar = 1; + peratom_flag = 1; + size_peratom_cols = 3; + peratom_freq = every; + extvector = 0; + if (virialflag) { vector_flag = 1; size_vector = 6; - extvector = 1; } if (addflag) { @@ -135,7 +146,7 @@ FixMDIQM::~FixMDIQM() // send exit command to engine if it is a stand-alone code // for plugin, this happens in MDIPlugin::plugin_wrapper() - if (!plugin) { + if (!plugin && !extflag) { int ierr = MDI_Send_command("EXIT", mdicomm); if (ierr) error->all(FLERR, "MDI: EXIT command"); } @@ -169,6 +180,8 @@ void FixMDIQM::init() // also initializes mdicomm // set plugin = 0/1 for engine = stand-alone code vs plugin library + if (!extflag) { + if (mdicomm == MDI_COMM_NULL) { MDI_Get_communicator(&mdicomm, 0); if (mdicomm == MDI_COMM_NULL) { @@ -185,16 +198,23 @@ void FixMDIQM::init() } } + } else { + plugin = 0; + mdicomm = lmp->mdicomm; + } + // send natoms, atom types, and simulation box to engine // this will trigger setup of a new system // subsequent calls in post_force() will be for same system until new init() + reallocate(); + int ierr = MDI_Send_command(">NATOMS", mdicomm); if (ierr) error->all(FLERR, "MDI: >NATOMS command"); int n = static_cast (atom->natoms); ierr = MDI_Send(&n, 1, MDI_INT, mdicomm); if (ierr) error->all(FLERR, "MDI: >NATOMS data"); - + send_types(); send_box(); } @@ -293,31 +313,25 @@ void FixMDIQM::post_force(int vflag) } // optionally request pressure tensor from MDI engine, convert to virial - // divide by nprocs so each proc stores a portion - // MPI_Allreduce is performed in compute_vector() // qm_virial = fix output for global QM virial if (virialflag) { - double ptensor[6]; ierr = MDI_Send_command("all(FLERR, "MDI: all(FLERR, "MDI: xprd * domain->yprd * domain->zprd; - for (int i = 0; i < 6; i++) { - ptensor[i] *= mdi2lmp_pressure; - qm_virial[i] = ptensor[i] * volume / force->nktv2p / nprocs; - } - sumflag = 0; + for (int i = 0; i < 6; i++) + qm_virial[i] *= mdi2lmp_pressure; } // optionally set fix->virial + // divide by nprocs so each proc stores a portion if (virialflag && addflag) { for (int i = 0; i < 6; i++) - virial[i] = qm_virial[i]; + virial[i] = qm_virial[i]/nprocs; } } @@ -343,14 +357,7 @@ double FixMDIQM::compute_scalar() double FixMDIQM::compute_vector(int n) { - // only sum across procs one time - - if (sumflag == 0) { - MPI_Allreduce(qm_virial, qm_virial_all, 6, MPI_DOUBLE, MPI_SUM, world); - sumflag = 1; - } - - return qm_virial_all[n]; + return qm_virial[n]; } /* ---------------------------------------------------------------------- @@ -388,7 +395,8 @@ void FixMDIQM::reallocate() void FixMDIQM::send_types() { - memset(ibuf1, 0, atom->natoms * sizeof(int)); + int n = static_cast (atom->natoms); + memset(ibuf1, 0, n * sizeof(int)); // use local atomID to index into ordered ibuf1 @@ -402,10 +410,11 @@ void FixMDIQM::send_types() ibuf1[index] = type[i]; } - int n = static_cast (atom->natoms); MPI_Reduce(ibuf1, ibuf1all, n, MPI_INT, MPI_SUM, 0, world); - int ierr = MDI_Send(ibuf1all, n, MDI_INT, mdicomm); + int ierr = MDI_Send_command(">TYPES", mdicomm); + if (ierr) error->all(FLERR, "MDI: >TYPES command"); + ierr = MDI_Send(ibuf1all, n, MDI_INT, mdicomm); if (ierr) error->all(FLERR, "MDI: >TYPES data"); } diff --git a/src/MDI/fix_mdi_qm.h b/src/MDI/fix_mdi_qm.h index 95b4bcbe6d..b805f7e3d2 100644 --- a/src/MDI/fix_mdi_qm.h +++ b/src/MDI/fix_mdi_qm.h @@ -40,7 +40,7 @@ class FixMDIQM : public Fix { private: int nprocs; - int virialflag,addflag,every; + int virialflag,addflag,extflag,every; int plugin; int maxlocal; int sumflag; diff --git a/src/MDI/mdi_command.cpp b/src/MDI/mdi_command.cpp index 65e47e197a..9fdc1f8a04 100644 --- a/src/MDI/mdi_command.cpp +++ b/src/MDI/mdi_command.cpp @@ -31,8 +31,26 @@ void MDICommand::command(int narg, char **arg) if (strcmp(arg[0], "engine") == 0) { MDIEngine(lmp, narg - 1, &arg[1]); + } else if (strcmp(arg[0], "plugin") == 0) { MDIPlugin(lmp, narg - 1, &arg[1]); - } else - error->all(FLERR, "Illegal mdi command"); + + } else if (strcmp(arg[0], "start") == 0) { + MDI_Comm mdicomm; + MDI_Get_communicator(&mdicomm, 0); + if (mdicomm == MDI_COMM_NULL) { + MDI_Accept_communicator(&mdicomm); + if (mdicomm == MDI_COMM_NULL) + error->all(FLERR, "MDI unable to connect to stand-alone engine"); + } else error->all(FLERR, "Cannot use mdi start in plugin mode"); + lmp->mdicomm = mdicomm; + + } else if (strcmp(arg[0], "stop") == 0) { + + MDI_Comm mdicomm = lmp->mdicomm; + int ierr = MDI_Send_command("EXIT", mdicomm); + if (ierr) error->all(FLERR, "MDI: EXIT command"); + lmp->mdicomm = MDI_COMM_NULL; + + } else error->all(FLERR, "Illegal mdi command"); } diff --git a/src/lammps.cpp b/src/lammps.cpp index c74983be43..d4c7288451 100644 --- a/src/lammps.cpp +++ b/src/lammps.cpp @@ -129,9 +129,8 @@ LAMMPS::LAMMPS(int narg, char **arg, MPI_Comm communicator) : version = (const char *) LAMMPS_VERSION; num_ver = utils::date2num(version); - clientserver = 0; - cslib = nullptr; - cscomm = 0; + external_comm = 0; + mdicomm = 0; skiprunflag = 0; @@ -155,19 +154,16 @@ LAMMPS::LAMMPS(int narg, char **arg, MPI_Comm communicator) : #endif // check if -mpicolor is first arg - // if so, then 2 apps were launched with one mpirun command + // if so, then 2 or more apps were launched with one mpirun command // this means passed communicator (e.g. MPI_COMM_WORLD) is bigger than LAMMPS - // e.g. for client/server coupling with another code - // in the future LAMMPS might leverage this in other ways // universe communicator needs to shrink to be just LAMMPS // syntax: -mpicolor color - // color = integer for this app, different than other app(s) + // color = integer for this app, different than any other app(s) // do the following: // perform an MPI_Comm_split() to create a new LAMMPS-only subcomm - // NOTE: this assumes other app(s) does same thing, else will hang! + // NOTE: this assumes other app(s) make same call, else will hang! // re-create universe with subcomm - // store full multi-app comm in cscomm - // cscomm is used by CSLIB package to exchange messages w/ other app + // store comm that all apps belong to in external_comm int iarg = 1; if (narg-iarg >= 2 && (strcmp(arg[iarg],"-mpicolor") == 0 || @@ -178,7 +174,7 @@ LAMMPS::LAMMPS(int narg, char **arg, MPI_Comm communicator) : int color = atoi(arg[iarg+1]); MPI_Comm subcomm; MPI_Comm_split(communicator,color,me,&subcomm); - cscomm = communicator; + external_comm = communicator; communicator = subcomm; delete universe; universe = new Universe(this,communicator); @@ -290,7 +286,7 @@ LAMMPS::LAMMPS(int narg, char **arg, MPI_Comm communicator) : logflag = iarg + 1; iarg += 2; - } else if (strcmp(arg[iarg],"-mpi") == 0 || + } else if (strcmp(arg[iarg],"-mpicolor") == 0 || strcmp(arg[iarg],"-m") == 0) { if (iarg+2 > narg) error->universe_all(FLERR,"Invalid command-line argument"); @@ -762,13 +758,13 @@ LAMMPS::~LAMMPS() delete [] suffix2; delete [] suffixp; - // free the MPI comm created by -mpi command-line arg processed in constructor + // free the MPI comm created by -mpicolor cmdline arg processed in constructor // it was passed to universe as if original universe world // may have been split later by partitions, universe will free the splits // free a copy of uorig here, so check in universe destructor will still work MPI_Comm copy = universe->uorig; - if (cscomm) MPI_Comm_free(©); + if (external_comm) MPI_Comm_free(©); delete input; delete universe; diff --git a/src/lammps.h b/src/lammps.h index 4f3e9cf110..04ab9a9673 100644 --- a/src/lammps.h +++ b/src/lammps.h @@ -61,13 +61,15 @@ class LAMMPS { char *suffix, *suffix2, *suffixp; // suffixes to add to input script style names int suffix_enable; // 1 if suffixes are enabled, 0 if disabled char *exename; // pointer to argv[0] - // + char ***packargs; // arguments for cmdline package commands int num_package; // number of cmdline package commands - // - int clientserver; // 0 = neither, 1 = client, 2 = server - void *cslib; // client/server messaging via CSlib - MPI_Comm cscomm; // MPI comm for client+server in mpi/one mode + + MPI_Comm external_comm; // MPI comm encompassing external programs + // when multiple programs launched by mpirun + // set by -mpicolor command line arg + + int mdicomm; // for use with MDI code coupling library const char *match_style(const char *style, const char *name); static const char *installed_packages[]; From 9842879db188b008d7bd70bf385b1b65f1a964fa Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 15 Jun 2022 08:14:53 -0400 Subject: [PATCH 363/585] fix typos --- doc/src/kspace_style.rst | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/doc/src/kspace_style.rst b/doc/src/kspace_style.rst index 59efbdc5bd..30f3e550c5 100644 --- a/doc/src/kspace_style.rst +++ b/doc/src/kspace_style.rst @@ -129,8 +129,8 @@ Examples kspace_style pppm 1.0e-4 kspace_style pppm/cg 1.0e-5 1.0e-6 - kspace style msm 1.0e-4 - kspace style scafacos fmm 1.0e-4 + kspace_style msm 1.0e-4 + kspace_style scafacos fmm 1.0e-4 kspace_style none Used in input scripts: From 1403a0dd94a4540c1561fc833d3bd2b73b03397a Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Wed, 15 Jun 2022 08:22:59 -0600 Subject: [PATCH 364/585] update affilication for Zhen Li --- doc/src/Packages_details.rst | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/doc/src/Packages_details.rst b/doc/src/Packages_details.rst index aaac06a4a8..b5d704190e 100644 --- a/doc/src/Packages_details.rst +++ b/doc/src/Packages_details.rst @@ -657,7 +657,7 @@ advection-diffusion-reaction systems. The equations of motion of these DPD extensions are integrated through a modified velocity-Verlet (MVV) algorithm. -**Author:** Zhen Li (Division of Applied Mathematics, Brown University) +**Author:** Zhen Li (Department of Mechanical Engineering, Clemson University) **Supporting info:** From 12d6983c9b8102216a829c207ef9b025a5c6eb4c Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Wed, 15 Jun 2022 17:08:54 -0600 Subject: [PATCH 365/585] more example bug fixes --- examples/mdi/README | 288 +++--------------- examples/mdi/Run.sh | 256 ++++++++++++++++ examples/mdi/in.sequence.python | 1 + examples/mdi/in.series.alone | 6 +- examples/mdi/in.series.driver | 15 +- examples/mdi/in.series.driver.plugin | 6 +- examples/mdi/in.snapshot.driver.plugin | 2 +- examples/mdi/log.7Apr22.mdi.aimd.alone.g++.1 | 90 ------ .../mdi/log.7Apr22.mdi.aimd.driver.mpi.g++.1 | 79 ----- .../mdi/log.7Apr22.mdi.aimd.driver.mpi.g++.3 | 79 ----- .../log.7Apr22.mdi.aimd.driver.plugin.g++.1 | 80 ----- .../log.7Apr22.mdi.aimd.driver.plugin.g++.3 | 80 ----- .../mdi/log.7Apr22.mdi.aimd.driver.tcp.g++.1 | 79 ----- .../mdi/log.7Apr22.mdi.aimd.driver.tcp.g++.3 | 79 ----- .../mdi/log.7Apr22.mdi.aimd.engine.mpi.g++.1 | 55 ---- .../mdi/log.7Apr22.mdi.aimd.engine.mpi.g++.4 | 55 ---- .../log.7Apr22.mdi.aimd.engine.plugin.g++.1 | 55 ---- .../log.7Apr22.mdi.aimd.engine.plugin.g++.3 | 55 ---- .../mdi/log.7Apr22.mdi.aimd.engine.tcp.g++.1 | 55 ---- .../mdi/log.7Apr22.mdi.aimd.engine.tcp.g++.4 | 55 ---- .../log.7Apr22.mdi.aimdpy.driver.mpi.g++.1 | 5 - .../log.7Apr22.mdi.aimdpy.driver.mpi.g++.2 | 5 - .../log.7Apr22.mdi.aimdpy.driver.tcp.g++.1 | 6 - .../log.7Apr22.mdi.aimdpy.driver.tcp.g++.2 | 6 - .../mdi/log.7Apr22.mdi.aimdpy.mm.mpi.g++.1 | 44 --- .../mdi/log.7Apr22.mdi.aimdpy.mm.mpi.g++.2 | 44 --- .../mdi/log.7Apr22.mdi.aimdpy.mm.tcp.g++.1 | 44 --- .../mdi/log.7Apr22.mdi.aimdpy.mm.tcp.g++.2 | 44 --- .../mdi/log.7Apr22.mdi.aimdpy.qm.mpi.g++.1 | 55 ---- .../mdi/log.7Apr22.mdi.aimdpy.qm.mpi.g++.3 | 55 ---- .../mdi/log.7Apr22.mdi.aimdpy.qm.tcp.g++.1 | 55 ---- .../mdi/log.7Apr22.mdi.aimdpy.qm.tcp.g++.3 | 55 ---- .../log.7Apr22.mdi.sequence.driver.mpi.g++.1 | 3 - .../log.7Apr22.mdi.sequence.driver.mpi.g++.2 | 3 - ...og.7Apr22.mdi.sequence.driver.plugin.g++.1 | 3 - ...og.7Apr22.mdi.sequence.driver.plugin.g++.3 | 3 - .../log.7Apr22.mdi.sequence.driver.tcp.g++.1 | 3 - .../log.7Apr22.mdi.sequence.driver.tcp.g++.2 | 3 - .../log.7Apr22.mdi.sequence.engine.mpi.g++.1 | 89 ------ .../log.7Apr22.mdi.sequence.engine.mpi.g++.4 | 89 ------ ...og.7Apr22.mdi.sequence.engine.plugin.g++.1 | 89 ------ ...og.7Apr22.mdi.sequence.engine.plugin.g++.3 | 89 ------ .../log.7Apr22.mdi.sequence.engine.tcp.g++.1 | 89 ------ .../log.7Apr22.mdi.sequence.engine.tcp.g++.4 | 89 ------ src/MDI/fix_mdi_qm.cpp | 79 +++-- src/MDI/fix_mdi_qm.h | 2 +- src/MDI/mdi_command.cpp | 39 ++- src/lammps.cpp | 2 +- src/lammps.h | 2 +- 49 files changed, 389 insertions(+), 2175 deletions(-) create mode 100644 examples/mdi/Run.sh delete mode 100644 examples/mdi/log.7Apr22.mdi.aimd.alone.g++.1 delete mode 100644 examples/mdi/log.7Apr22.mdi.aimd.driver.mpi.g++.1 delete mode 100644 examples/mdi/log.7Apr22.mdi.aimd.driver.mpi.g++.3 delete mode 100644 examples/mdi/log.7Apr22.mdi.aimd.driver.plugin.g++.1 delete mode 100644 examples/mdi/log.7Apr22.mdi.aimd.driver.plugin.g++.3 delete mode 100644 examples/mdi/log.7Apr22.mdi.aimd.driver.tcp.g++.1 delete mode 100644 examples/mdi/log.7Apr22.mdi.aimd.driver.tcp.g++.3 delete mode 100644 examples/mdi/log.7Apr22.mdi.aimd.engine.mpi.g++.1 delete mode 100644 examples/mdi/log.7Apr22.mdi.aimd.engine.mpi.g++.4 delete mode 100644 examples/mdi/log.7Apr22.mdi.aimd.engine.plugin.g++.1 delete mode 100644 examples/mdi/log.7Apr22.mdi.aimd.engine.plugin.g++.3 delete mode 100644 examples/mdi/log.7Apr22.mdi.aimd.engine.tcp.g++.1 delete mode 100644 examples/mdi/log.7Apr22.mdi.aimd.engine.tcp.g++.4 delete mode 100644 examples/mdi/log.7Apr22.mdi.aimdpy.driver.mpi.g++.1 delete mode 100644 examples/mdi/log.7Apr22.mdi.aimdpy.driver.mpi.g++.2 delete mode 100644 examples/mdi/log.7Apr22.mdi.aimdpy.driver.tcp.g++.1 delete mode 100644 examples/mdi/log.7Apr22.mdi.aimdpy.driver.tcp.g++.2 delete mode 100644 examples/mdi/log.7Apr22.mdi.aimdpy.mm.mpi.g++.1 delete mode 100644 examples/mdi/log.7Apr22.mdi.aimdpy.mm.mpi.g++.2 delete mode 100644 examples/mdi/log.7Apr22.mdi.aimdpy.mm.tcp.g++.1 delete mode 100644 examples/mdi/log.7Apr22.mdi.aimdpy.mm.tcp.g++.2 delete mode 100644 examples/mdi/log.7Apr22.mdi.aimdpy.qm.mpi.g++.1 delete mode 100644 examples/mdi/log.7Apr22.mdi.aimdpy.qm.mpi.g++.3 delete mode 100644 examples/mdi/log.7Apr22.mdi.aimdpy.qm.tcp.g++.1 delete mode 100644 examples/mdi/log.7Apr22.mdi.aimdpy.qm.tcp.g++.3 delete mode 100644 examples/mdi/log.7Apr22.mdi.sequence.driver.mpi.g++.1 delete mode 100644 examples/mdi/log.7Apr22.mdi.sequence.driver.mpi.g++.2 delete mode 100644 examples/mdi/log.7Apr22.mdi.sequence.driver.plugin.g++.1 delete mode 100644 examples/mdi/log.7Apr22.mdi.sequence.driver.plugin.g++.3 delete mode 100644 examples/mdi/log.7Apr22.mdi.sequence.driver.tcp.g++.1 delete mode 100644 examples/mdi/log.7Apr22.mdi.sequence.driver.tcp.g++.2 delete mode 100644 examples/mdi/log.7Apr22.mdi.sequence.engine.mpi.g++.1 delete mode 100644 examples/mdi/log.7Apr22.mdi.sequence.engine.mpi.g++.4 delete mode 100644 examples/mdi/log.7Apr22.mdi.sequence.engine.plugin.g++.1 delete mode 100644 examples/mdi/log.7Apr22.mdi.sequence.engine.plugin.g++.3 delete mode 100644 examples/mdi/log.7Apr22.mdi.sequence.engine.tcp.g++.1 delete mode 100644 examples/mdi/log.7Apr22.mdi.sequence.engine.tcp.g++.4 diff --git a/examples/mdi/README b/examples/mdi/README index 9298e9c59c..9380e2e79a 100644 --- a/examples/mdi/README +++ b/examples/mdi/README @@ -21,9 +21,9 @@ a driver and couple to an engine that is either a stand-alone code or a plugin. Examples for all these use cases are in this directory. The example commands below illustrate how to run all the variants. -To use LAMMPS as a plugin engine, you must build it as a shared library. -Something like this, which also builds the normal LAMMPS executable -lmp_mpi: +To use LAMMPS as a plugin engine, you must build it as a shared +library. Something like this with make, which also builds the normal +LAMMPS executable lmp_mpi: cd src make yes-mdi @@ -33,189 +33,59 @@ To use the serial_driver.py example you will need Python 3 with Numpy and mpi4py available in your Python. Make sure LAMMPS and Python are using same the same version of MPI. +5 use-case examples are explained below. + +See the Run.sh file for commands to run each of the examples +in all the different modes. + +In the first 3 examples, results running with MDI should be identical +to running without MDI (alone log files). Example #4 has no non-MDI +run. Example #5 results should match the non-MDI run of example #1. + ------------------------------------------------- ------------------------------------------------- -* Example #1 = run ab inito MD (AIMD) - Two instances of LAMMPS operate as a driver and engine - As an engine, LAMMPS is a surrogate for a quantum code +* Example #1 = run ab initio MD (AIMD) + +See the log aimd files. + +Two instances of LAMMPS operate as a driver and engine. As an engine, +LAMMPS is a surrogate for a quantum code. Note that the 2 input scripts in.aimd.alone and in.aimd.driver have an option for running in NVE vs NPT mode. Comment in/out the appropriate line to change modes. Nothing needs to be changed in the in.aimd.engine or in.aimd.engine.plugin scripts. ---- +------------------------------------------------- +------------------------------------------------- -Run the entire calculation with a single instance of LAMMPS by itself - results should be identical to running this example with MDI +* Example #2 = run LAMMPS, compute QM forces on snapshots from a long run -% lmp_mpi -log log.aimd.alone < in.aimd.alone +See the log snapshot and dump snapshot files. -With MDI, the thermo output of the driver should match the thermo -output of the in.aimd.alone script. - ---- - -Run with TCP: 1 proc each - -% lmp_mpi -mdi "-name LMP1 -role DRIVER -method TCP -port 8021" -log log.aimd.driver.tcp -in in.aimd.driver - -% lmp_mpi -mdi "-name LMP2 -role ENGINE -method TCP -port 8021 -hostname localhost" -log log.aimd.engine.tcp -in in.aimd.engine - ---- - -Run with TCP: 3 procs + 4 procs - -% mpirun -np 3 lmp_mpi -mdi "-name LMP1 -role DRIVER -method TCP -port 8021" -log log.aimd.driver.tcp -in in.aimd.driver - -% mpirun -np 4 lmp_mpi -mdi "-name LMP2 -role ENGINE -method TCP -port 8021 -hostname localhost" -log log.aimd.engine.tcp -in in.aimd.engine - ---- - -Run with MPI: 1 proc each - -% mpirun -np 1 lmp_mpi -mdi "-name LMP1 -role DRIVER -method MPI" -log log.aimd.driver.mpi -in in.aimd.driver : -np 1 lmp_mpi -mdi "-name LMP2 -role ENGINE -method MPI" -log log.aimd.engine.mpi -in in.aimd.engine - ---- - -Run with MPI: 3 procs + 4 procs - -% mpirun -np 3 lmp_mpi -mdi "-name LMP1 -role DRIVER -method MPI" -log log.aimd.driver.mpi -in in.aimd.driver : -np 4 lmp_mpi -mdi "-name LMP2 -role ENGINE -method MPI" -log log.aimd.engine.mpi -in in.aimd.engine - ---- - -Run in plugin mode: 1 proc - -% lmp_mpi -mdi "-name LMP1 -role DRIVER -method LINK -plugin_path /home/sjplimp/lammps/git/src" -log log.aimd.driver.plugin -in in.aimd.driver.plugin - ---- - -Run in plugin mode: 3 procs - -% mpirun -np 3 lmp_mpi -mdi "-name LMP1 -role DRIVER -method LINK -plugin_path /home/sjplimp/lammps/git/src" -log log.aimd.driver.plugin -in in.aimd.driver.plugin +Two instances of LAMMPS operate as a driver and engine. As an engine, +LAMMPS is a surrogate for a quantum code ------------------------------------------------- ------------------------------------------------- -* Example #1b = run LAMMPS, compute QM forces on snapshots from a long run - Two instances of LAMMPS operate as a driver and engine - As an engine, LAMMPS is a surrogate for a quantum code +* Example #3 = run LAMMPS, compute QM forces on series of independent systems ---- +files See the log series and dump series files. -Run the entire calculation with a single instance of LAMMPS by itself - results should be identical to running this example with MDI - -% lmp_mpi -log log.snapshot.alone < in.snapshot.alone - -With MDI, the thermo output of the driver should match the thermo -output of the in.snapshot.alone script. Likewise the dump file written -by the driver should match dump.snapshot.alone. - ---- - -Run with TCP: 1 proc each - -% lmp_mpi -mdi "-name LMP1 -role DRIVER -method TCP -port 8021" -log log.snapshot.driver.tcp -in in.snapshot.driver - -% lmp_mpi -mdi "-name LMP2 -role ENGINE -method TCP -port 8021 -hostname localhost" -log log.snapshot.engine.tcp -in in.snapshot.engine - ---- - -Run with TCP: 3 procs + 4 procs - -% mpirun -np 3 lmp_mpi -mdi "-name LMP1 -role DRIVER -method TCP -port 8021" -log log.snapshot.driver.tcp -in in.snapshot.driver - -% mpirun -np 4 lmp_mpi -mdi "-name LMP2 -role ENGINE -method TCP -port 8021 -hostname localhost" -log log.snapshot.engine.tcp -in in.snapshot.engine - ---- - -Run with MPI: 1 proc each - -% mpirun -np 1 lmp_mpi -mdi "-name LMP1 -role DRIVER -method MPI" -log log.snapshot.driver.mpi -in in.snapshot.driver : -np 1 lmp_mpi -mdi "-name LMP2 -role ENGINE -method MPI" -log log.snapshot.engine.mpi -in in.snapshot.engine - ---- - -Run with MPI: 3 procs + 4 procs - -% mpirun -np 3 lmp_mpi -mdi "-name LMP1 -role DRIVER -method MPI" -log log.snapshot.driver.mpi -in in.snapshot.driver : -np 4 lmp_mpi -mdi "-name LMP2 -role ENGINE -method MPI" -log log.snapshot.engine.mpi -in in.snapshot.engine - ---- - -Run in plugin mode: 1 proc - -% lmp_mpi -mdi "-name LMP1 -role DRIVER -method LINK -plugin_path /home/sjplimp/lammps/git/src" -log log.snapshot.driver.plugin -in in.snapshot.driver.plugin - ---- - -Run in plugin mode: 3 procs - -% mpirun -np 3 lmp_mpi -mdi "-name LMP1 -role DRIVER -method LINK -plugin_path /home/sjplimp/lammps/git/src" -log log.snapshot.driver.plugin -in in.snapshot.driver.plugin +Two instances of LAMMPS operate as a driver and engine. As an engine, +LAMMPS is a surrogate for a quantum code ------------------------------------------------- ------------------------------------------------- -* Example #1c = run LAMMPS, compute QM forces on series of independent systems - Two instances of LAMMPS operate as a driver and engine - As an engine, LAMMPS is a surrogate for a quantum code +* Example #4 = Python driver runs a sequence of unrelated LAMMPS calculations ---- +See the log sequence files. -Run the entire calculation with a single instance of LAMMPS by itself - results should be identical to running this example with MDI - -% lmp_mpi -log log.series.alone < in.series.alone - -With MDI, the thermo output of the driver should match the thermo -output of the in.series.alone script. Likewise the dump files written -by the driver should match dump.series.alone files. - ---- - -Run with TCP: 1 proc each - -% lmp_mpi -mdi "-name LMP1 -role DRIVER -method TCP -port 8021" -log log.series.driver.tcp -in in.series.driver - -% lmp_mpi -mdi "-name LMP2 -role ENGINE -method TCP -port 8021 -hostname localhost" -log log.series.engine.tcp -in in.series.engine - ---- - -Run with TCP: 3 procs + 4 procs - -% mpirun -np 3 lmp_mpi -mdi "-name LMP1 -role DRIVER -method TCP -port 8021" -log log.series.driver.tcp -in in.series.driver - -% mpirun -np 4 lmp_mpi -mdi "-name LMP2 -role ENGINE -method TCP -port 8021 -hostname localhost" -log log.series.engine.tcp -in in.series.engine - ---- - -Run with MPI: 1 proc each - -% mpirun -np 1 lmp_mpi -mdi "-name LMP1 -role DRIVER -method MPI" -log log.series.driver.mpi -in in.series.driver : -np 1 lmp_mpi -mdi "-name LMP2 -role ENGINE -method MPI" -log log.series.engine.mpi -in in.series.engine - ---- - -Run with MPI: 3 procs + 4 procs - -% mpirun -np 3 lmp_mpi -mdi "-name LMP1 -role DRIVER -method MPI" -log log.series.driver.mpi -in in.series.driver : -np 4 lmp_mpi -mdi "-name LMP2 -role ENGINE -method MPI" -log log.series.engine.mpi -in in.series.engine - ---- - -Run in plugin mode: 1 proc - -% lmp_mpi -mdi "-name LMP1 -role DRIVER -method LINK -plugin_path /home/sjplimp/lammps/git/src" -log log.series.driver.plugin -in in.series.driver.plugin - ---- - -Run in plugin mode: 3 procs - -% mpirun -np 3 lmp_mpi -mdi "-name LMP1 -role DRIVER -method LINK -plugin_path /home/sjplimp/lammps/git/src" -log log.series.driver.plugin -in in.series.driver.plugin - -------------------------------------------------- -------------------------------------------------- - -* Example #2 = Python driver runs a sequence of unrelated LAMMPS calculations - Each calculation can be a single-point evaluation, MD run, or minimization +Each calculation can be a single-point evaluation, MD run, or +minimization The sequence_driver.py code allows for optional switches in addition to -mdi (required) and the -plugin and -plugin_args switches which are @@ -244,101 +114,21 @@ copied here: # -seed 12345 # random number seed > 0, default = 12345 ---- - -Run with TCP: 1 proc each - -% python3 sequence_driver.py -mdi "-role DRIVER -name sequence -method TCP -port 8021" - -% lmp_mpi -mdi "-role ENGINE -name LMP -method TCP -port 8021 -hostname localhost" -log log.sequence -in in.sequence.python - ---- - -Run with TCP: 2 proc + 4 procs - -% mpirun -np 2 python3 sequence_driver.py -mdi "-role DRIVER -name sequence -method TCP -port 8021" - -% mpirun -np 4 lmp_mpi -mdi "-role ENGINE -name LMP -method TCP -port 8021 -hostname localhost" -log log.sequence -in in.sequence.python - ---- - -Run with MPI: 1 proc each - -% mpirun -np 1 python3 sequence_driver.py -mdi "-role DRIVER -name sequence -method MPI" : -np 1 lmp_mpi -mdi "-role ENGINE -name LAMMPS -method MPI" -log log.sequence -in in.sequence.python - ---- - -Run with MPI: 2 procs + 4 procs - -% mpirun -np 2 python3 sequence_driver.py -mdi "-role DRIVER -name sequence -method MPI" : -np 4 lmp_mpi -mdi "-role ENGINE -name LMP -method MPI" -log log.sequence -in in.sequence.python - ---- - -Run in plugin mode: 1 proc - -% python3 sequence_driver.py -plugin lammps -mdi "-role DRIVER -name sequence -method LINK -plugin_path /home/sjplimp/lammps/git/src" -plugin_args "-log log.sequence -in in.sequence".python - ---- - -Run in plugin mode: 3 procs - -% mpirun -np 3 python3 sequence_driver.py -plugin lammps -mdi "-role DRIVER -name sequence -method LINK -plugin_path /home/sjplimp/lammps/git/src" -plugin_args "-log log.sequence -in in.sequence".python - ------------------------------------------------- ------------------------------------------------- -* Example #3 = run AIMD with Python driver code and 2 LAMMPS instances as engines - First LAMMPS instance performs the MD timestepping - Second LAMMPS instance is surrogate QM = computes forces +* Example #5 = run AIMD with Python driver code and 2 LAMMPS instances as engines + +See the log aimdpy files. + +First LAMMPS instance performs the MD timestepping. Second LAMMPS +instance is surrogate QM to compute forces. The aimd_driver.py code allows for an optional switch in addition to -mdi (required) and the -plugin and -plugin_args swiches which are used to link to the 2 engines as a plugin libraries. The example run commands below use the default values of the optional switch. The -switch is also explained the top of the file; the info is copied -here: +switch is also explained the top of the file; the info is copied here: # -nsteps 5 # number of timesteps in dynamics runs, default = 5 - ---- - -Run the entire calculation with a single instance of LAMMPS by itself - results should be identical to running this example with MDI - -% lmp_mpi -log log.aimd.alone < in.aimd.alone - -With MDI, the driver prints the QM and Total energies. These should -match the PotEng and TotEng output of the in.aimd.alone script. - ---- - -Run with TCP: 1 proc each - -% python3 aimd_driver.py -mdi "-role DRIVER -name aimd -method TCP -port 8021" - -% lmp_mpi -mdi "-role ENGINE -name MM -method TCP -port 8021 -hostname localhost" -log log.aimd.mm -in in.aimd.mm - -% lmp_mpi -mdi "-role ENGINE -name QM -method TCP -port 8021 -hostname localhost" -log log.aimd.qm -in in.aimd.qm - ---- - -Run with TCP: 2 procs + 2 procs + 3 procs - -% mpirun -np 2 python3 aimd_driver.py -mdi "-role DRIVER -name aimd -method TCP -port 8021" - -% mpirun -np 2 lmp_mpi -mdi "-role ENGINE -name MM -method TCP -port 8021 -hostname localhost" -log log.aimd.mm -in in.aimd.mm - -% mpirun -np 3 lmp_mpi -mdi "-role ENGINE -name QM -method TCP -port 8021 -hostname localhost" -log log.aimd.qm -in in.aimd.qm - ---- - -Run with MPI: 1 proc each - -% mpirun -np 1 python3 aimd_driver.py -mdi "-role DRIVER -name aimd -method MPI" : -np 1 lmp_mpi -mdi "-role ENGINE -name MM -method MPI" -log log.aimd.mm -in in.aimd.mm : -np 1 lmp_mpi -mdi "-role ENGINE -name QM -method MPI" -log log.aimd.qm -in in.aimd.qm - ---- - -Run with MPI: 2 procs + 2 procs + 3 procs - -% mpirun -np 2 python3 aimd_driver.py -mdi "-role DRIVER -name aimd -method MPI" : -np 2 lmp_mpi -mdi "-role ENGINE -name MM -method MPI" -log log.aimd.mm -in in.aimd.mm : -np 3 lmp_mpi -mdi "-role ENGINE -name QM -method MPI" -log log.aimd.qm -in in.aimd.qm diff --git a/examples/mdi/Run.sh b/examples/mdi/Run.sh new file mode 100644 index 0000000000..55c5638841 --- /dev/null +++ b/examples/mdi/Run.sh @@ -0,0 +1,256 @@ +# Run all the examples + +# ------------------------------------------------- +# ------------------------------------------------- + +# Example 1 + +# --- + +# Run without MDI + +lmp_mpi -log log.aimd.alone.1 < in.aimd.alone + +# --- + +# Run with TCP: 1 proc each + +lmp_mpi -mdi "-name LMP1 -role DRIVER -method TCP -port 8021" -log log.aimd.driver.tcp.1 -in in.aimd.driver & + +lmp_mpi -mdi "-name LMP2 -role ENGINE -method TCP -port 8021 -hostname localhost" -log log.aimd.engine.tcp.1 -in in.aimd.engine + +# --- + +# Run with TCP: 3 procs + 4 procs + +mpirun -np 3 lmp_mpi -mdi "-name LMP1 -role DRIVER -method TCP -port 8021" -log log.aimd.driver.tcp.3 -in in.aimd.driver & + +mpirun -np 4 lmp_mpi -mdi "-name LMP2 -role ENGINE -method TCP -port 8021 -hostname localhost" -log log.aimd.engine.tcp.4 -in in.aimd.engine + +# --- + +# Run with MPI: 1 proc each + +mpirun -np 1 lmp_mpi -mdi "-name LMP1 -role DRIVER -method MPI" -log log.aimd.driver.mpi.1 -in in.aimd.driver : -np 1 lmp_mpi -mdi "-name LMP2 -role ENGINE -method MPI" -log log.aimd.engine.mpi.1 -in in.aimd.engine + +# --- + +# Run with MPI: 3 procs + 4 procs + +mpirun -np 3 lmp_mpi -mdi "-name LMP1 -role DRIVER -method MPI" -log log.aimd.driver.mpi.3 -in in.aimd.driver : -np 4 lmp_mpi -mdi "-name LMP2 -role ENGINE -method MPI" -log log.aimd.engine.mpi.4 -in in.aimd.engine + +# --- + +# Run in plugin mode: 1 proc + +lmp_mpi -mdi "-name LMP1 -role DRIVER -method LINK -plugin_path /home/sjplimp/lammps/git/src" -log log.aimd.driver.plugin.1 -in in.aimd.driver.plugin +mv log.aimd.engine.plugin log.aimd.engine.plugin.1 + +# --- + +# Run in plugin mode: 3 procs + +mpirun -np 3 lmp_mpi -mdi "-name LMP1 -role DRIVER -method LINK -plugin_path /home/sjplimp/lammps/git/src" -log log.aimd.driver.plugin.3 -in in.aimd.driver.plugin +mv log.aimd.engine.plugin log.aimd.engine.plugin.3 + +# ------------------------------------------------- +# ------------------------------------------------- + +# Example 2 + +# --- + +# Run without MDI + +lmp_mpi -log log.snapshot.alone.1 < in.snapshot.alone +mv dump.snapshot.alone dump.snapshot.alone.1 + +# --- + +# Run with TCP: 1 proc each + +lmp_mpi -mdi "-name LMP1 -role DRIVER -method TCP -port 8021" -log log.snapshot.driver.tcp.1 -in in.snapshot.driver & + +lmp_mpi -mdi "-name LMP2 -role ENGINE -method TCP -port 8021 -hostname localhost" -log log.snapshot.engine.tcp.1 -in in.snapshot.engine +mv dump.snapshot.driver dump.snapshot.driver.tcp.1 + +# --- + +# Run with TCP: 3 procs + 4 procs + +mpirun -np 3 lmp_mpi -mdi "-name LMP1 -role DRIVER -method TCP -port 8021" -log log.snapshot.driver.tcp.3 -in in.snapshot.driver & + +mpirun -np 4 lmp_mpi -mdi "-name LMP2 -role ENGINE -method TCP -port 8021 -hostname localhost" -log log.snapshot.engine.tcp.4 -in in.snapshot.engine +mv dump.snapshot.driver dump.snapshot.driver.tcp.3 + +# --- + +# Run with MPI: 1 proc each + +mpirun -np 1 lmp_mpi -mdi "-name LMP1 -role DRIVER -method MPI" -log log.snapshot.driver.mpi.1 -in in.snapshot.driver : -np 1 lmp_mpi -mdi "-name LMP2 -role ENGINE -method MPI" -log log.snapshot.engine.mpi.1 -in in.snapshot.engine +mv dump.snapshot.driver dump.snapshot.driver.mpi.1 + +# --- + +# Run with MPI: 3 procs + 4 procs + +mpirun -np 3 lmp_mpi -mdi "-name LMP1 -role DRIVER -method MPI" -log log.snapshot.driver.mpi.3 -in in.snapshot.driver : -np 4 lmp_mpi -mdi "-name LMP2 -role ENGINE -method MPI" -log log.snapshot.engine.mpi.3 -in in.snapshot.engine +mv dump.snapshot.driver dump.snapshot.driver.mpi.3 + +# --- + +# Run in plugin mode: 1 proc + +lmp_mpi -mdi "-name LMP1 -role DRIVER -method LINK -plugin_path /home/sjplimp/lammps/git/src" -log log.snapshot.driver.plugin.1 -in in.snapshot.driver.plugin +mv log.snapshot.engine.plugin log.snapshot.engine.plugin.1 +mv dump.snapshot.driver.plugin dump.snapshot.driver.plugin.1 + +# --- + +# Run in plugin mode: 3 procs + +mpirun -np 3 lmp_mpi -mdi "-name LMP1 -role DRIVER -method LINK -plugin_path /home/sjplimp/lammps/git/src" -log log.snapshot.driver.plugin.3 -in in.snapshot.driver.plugin +mv log.snapshot.engine.plugin log.snapshot.engine.plugin.3 +mv dump.snapshot.driver.plugin dump.snapshot.driver.plugin.3 + +# ------------------------------------------------- +# ------------------------------------------------- + +# Example 3 + +# --- + +# Run without MDI + +lmp_mpi -log log.series.alone.1 < in.series.alone +mv dump.series.alone dump.series.alone.1 + +# --- + +# Run with TCP: 1 proc each + +lmp_mpi -mdi "-name LMP1 -role DRIVER -method TCP -port 8021" -log log.series.driver.tcp.1 -in in.series.driver & + +lmp_mpi -mdi "-name LMP2 -role ENGINE -method TCP -port 8021 -hostname localhost" -log log.series.engine.tcp.1 -in in.series.engine +mv dump.series.driver dump.series.driver.tcp.1 + +# --- + +# Run with TCP: 3 procs + 4 procs + +mpirun -np 3 lmp_mpi -mdi "-name LMP1 -role DRIVER -method TCP -port 8021" -log log.series.driver.tcp.3 -in in.series.driver & + +mpirun -np 4 lmp_mpi -mdi "-name LMP2 -role ENGINE -method TCP -port 8021 -hostname localhost" -log log.series.engine.tcp.4 -in in.series.engine +mv dump.series.driver dump.series.driver.tcp.3 + +# --- + +# Run with MPI: 1 proc each + +mpirun -np 1 lmp_mpi -mdi "-name LMP1 -role DRIVER -method MPI" -log log.series.driver.mpi.1 -in in.series.driver : -np 1 lmp_mpi -mdi "-name LMP2 -role ENGINE -method MPI" -log log.series.engine.mpi.1 -in in.series.engine +mv dump.series.driver dump.series.driver.mpi.1 + +# --- + +# Run with MPI: 3 procs + 4 procs + +mpirun -np 3 lmp_mpi -mdi "-name LMP1 -role DRIVER -method MPI" -log log.series.driver.mpi.3 -in in.series.driver : -np 4 lmp_mpi -mdi "-name LMP2 -role ENGINE -method MPI" -log log.series.engine.mpi.4 -in in.series.engine +mv dump.series.driver dump.series.driver.mpi.3 + +# --- + +# Run in plugin mode: 1 proc + +lmp_mpi -mdi "-name LMP1 -role DRIVER -method LINK -plugin_path /home/sjplimp/lammps/git/src" -log log.series.driver.plugin.1 -in in.series.driver.plugin +mv log.series.engine.plugin log.series.engine.plugin.1 +mv dump.series.driver.plugin dump.series.driver.plugin.1 + +# --- + +# Run in plugin mode: 3 procs + +mpirun -np 3 lmp_mpi -mdi "-name LMP1 -role DRIVER -method LINK -plugin_path /home/sjplimp/lammps/git/src" -log log.series.driver.plugin.3 -in in.series.driver.plugin +mv log.series.engine.plugin log.series.engine.plugin.3 +mv dump.series.driver.plugin dump.series.driver.plugin.3 + +# ------------------------------------------------- +# ------------------------------------------------- + +# Example 4 + +# --- + +# Run with TCP: 1 proc each + +python3 sequence_driver.py -mdi "-role DRIVER -name sequence -method TCP -port 8021" & + +lmp_mpi -mdi "-role ENGINE -name LMP -method TCP -port 8021 -hostname localhost" -log log.sequence.engine.tcp.1 -in in.sequence.python + +# --- + +# Run with TCP: 2 proc + 4 procs + +mpirun -np 2 python3 sequence_driver.py -mdi "-role DRIVER -name sequence -method TCP -port 8021" & + +mpirun -np 4 lmp_mpi -mdi "-role ENGINE -name LMP -method TCP -port 8021 -hostname localhost" -log log.sequence.engine.tcp.4 -in in.sequence.python + +# --- + +# Run with MPI: 1 proc each + +mpirun -np 1 python3 sequence_driver.py -mdi "-role DRIVER -name sequence -method MPI" : -np 1 lmp_mpi -mdi "-role ENGINE -name LAMMPS -method MPI" -log log.sequence.engine.mpi.1 -in in.sequence.python + +# --- + +# Run with MPI: 2 procs + 4 procs + +mpirun -np 2 python3 sequence_driver.py -mdi "-role DRIVER -name sequence -method MPI" : -np 4 lmp_mpi -mdi "-role ENGINE -name LMP -method MPI" -log log.sequence.engine.mpi.4 -in in.sequence.python + +# --- + +# Run in plugin mode: 1 proc + +python3 sequence_driver.py -plugin lammps -mdi "-role DRIVER -name sequence -method LINK -plugin_path /home/sjplimp/lammps/git/src" -plugin_args "-log log.sequence.engine.plugin.1 -in in.sequence".python + +# --- + +# Run in plugin mode: 3 procs + +mpirun -np 3 python3 sequence_driver.py -plugin lammps -mdi "-role DRIVER -name sequence -method LINK -plugin_path /home/sjplimp/lammps/git/src" -plugin_args "-log log.sequence.engine.plugin.3 -in in.sequence".python + +# ------------------------------------------------- +# ------------------------------------------------- + +# Example 5 + +# --- + +# Run with TCP: 1 proc each + +python3 aimd_driver.py -mdi "-role DRIVER -name aimd -method TCP -port 8021" & + +lmp_mpi -mdi "-role ENGINE -name MM -method TCP -port 8021 -hostname localhost" -log log.aimdpy.mm.tcp.1 -in in.aimd.mm & + +lmp_mpi -mdi "-role ENGINE -name QM -method TCP -port 8021 -hostname localhost" -log log.aimdpy.qm.tcp.1 -in in.aimd.qm + +# --- + +# Run with TCP: 2 procs + 2 procs + 3 procs + +mpirun -np 2 python3 aimd_driver.py -mdi "-role DRIVER -name aimd -method TCP -port 8021" & + +mpirun -np 2 lmp_mpi -mdi "-role ENGINE -name MM -method TCP -port 8021 -hostname localhost" -log log.aimd.mm.tcp.2 -in in.aimd.mm & + +mpirun -np 3 lmp_mpi -mdi "-role ENGINE -name QM -method TCP -port 8021 -hostname localhost" -log log.aimd.qm.tcp.3 -in in.aimd.qm + +# --- + +# Run with MPI: 1 proc each + +mpirun -np 1 python3 aimd_driver.py -mdi "-role DRIVER -name aimd -method MPI" : -np 1 lmp_mpi -mdi "-role ENGINE -name MM -method MPI" -log log.aimd.mm.mpi.1 -in in.aimd.mm : -np 1 lmp_mpi -mdi "-role ENGINE -name QM -method MPI" -log log.aimd.qm.qm.1 -in in.aimd.qm + +# --- + +# Run with MPI: 2 procs + 2 procs + 3 procs + +mpirun -np 2 python3 aimd_driver.py -mdi "-role DRIVER -name aimd -method MPI" : -np 2 lmp_mpi -mdi "-role ENGINE -name MM -method MPI" -log log.aimd.mm.mpi.2 -in in.aimd.mm : -np 3 lmp_mpi -mdi "-role ENGINE -name QM -method MPI" -log log.aimd.qm.mpi.3 -in in.aimd.qm diff --git a/examples/mdi/in.sequence.python b/examples/mdi/in.sequence.python index c094326ae7..6f28922a66 100644 --- a/examples/mdi/in.sequence.python +++ b/examples/mdi/in.sequence.python @@ -19,3 +19,4 @@ fix 1 all nve thermo 10 mdi engine + diff --git a/examples/mdi/in.series.alone b/examples/mdi/in.series.alone index d08b72d386..f359581c50 100644 --- a/examples/mdi/in.series.alone +++ b/examples/mdi/in.series.alone @@ -4,7 +4,6 @@ variable x index 5 variable y index 5 variable z index 5 -variable ifile loop 3 variable rho index 0.7 0.8 0.9 label LOOP @@ -32,12 +31,11 @@ label LOOP run 0 - write_dump all custom dump.series.alone.${ifile} & - id type x y z fx fy fz modify sort id + write_dump all custom dump.series.alone & + id type x y z fx fy fz modify sort id append yes clear -next ifile next rho jump SELF LOOP diff --git a/examples/mdi/in.series.driver b/examples/mdi/in.series.driver index d8b4df1f8c..4089dd66ec 100644 --- a/examples/mdi/in.series.driver +++ b/examples/mdi/in.series.driver @@ -4,10 +4,9 @@ variable x index 5 variable y index 5 variable z index 5 -variable ifile loop 3 variable rho index 0.7 0.8 0.9 -mdi start +mdi connect label LOOP @@ -25,24 +24,20 @@ label LOOP neighbor 0.3 bin neigh_modify delay 0 every 1 check yes - fix 1 all mdi/qm add no virial yes external yes + fix 1 all mdi/qm add no virial yes connect no variable epress equal (f_1[1]+f_1[2]+f_1[3])/3 thermo_style custom step temp f_1 v_epress f_1[1] f_1[2] f_1[3] run 0 - write_dump all custom dump.series.driver.${ifile} & - id type x y z f_1[1] f_1[2] f_1[3] modify sort id + write_dump all custom dump.series.driver & + id type x y z f_1[1] f_1[2] f_1[3] modify sort id append yes - # cannot do "clear" b/c will shutdown MDI engine - # have to - clear -next ifile next rho jump SELF LOOP -mdi stop +mdi exit diff --git a/examples/mdi/in.series.driver.plugin b/examples/mdi/in.series.driver.plugin index 4a4364c447..8096b56886 100644 --- a/examples/mdi/in.series.driver.plugin +++ b/examples/mdi/in.series.driver.plugin @@ -4,7 +4,6 @@ variable x index 5 variable y index 5 variable z index 5 -variable ifile loop 3 variable rho index 0.7 0.8 0.9 label LOOP @@ -33,12 +32,11 @@ label LOOP extra "-log log.series.engine.plugin" & command "run 0" - write_dump all custom dump.series.driver.${ifile} & - id type x y z f_1[1] f_1[2] f_1[3] modify sort id + write_dump all custom dump.series.driver.plugin & + id type x y z f_1[1] f_1[2] f_1[3] modify sort id append yes clear -next ifile next rho jump SELF LOOP diff --git a/examples/mdi/in.snapshot.driver.plugin b/examples/mdi/in.snapshot.driver.plugin index 7592c5fb59..2fdca3f6cd 100644 --- a/examples/mdi/in.snapshot.driver.plugin +++ b/examples/mdi/in.snapshot.driver.plugin @@ -32,7 +32,7 @@ thermo_style custom step temp pe c_1 c_1[1] c_1[2] c_1[3] thermo 100 -dump 1 all custom 500 dump.snapshot.driver & +dump 1 all custom 500 dump.snapshot.driver.plugin & id type x y z f_2[1] f_2[2] f_2[3] dump_modify 1 sort id diff --git a/examples/mdi/log.7Apr22.mdi.aimd.alone.g++.1 b/examples/mdi/log.7Apr22.mdi.aimd.alone.g++.1 deleted file mode 100644 index 5fa3743530..0000000000 --- a/examples/mdi/log.7Apr22.mdi.aimd.alone.g++.1 +++ /dev/null @@ -1,90 +0,0 @@ -LAMMPS (17 Feb 2022) -# 3d Lennard-Jones melt - MDI driver script - -variable x index 5 -variable y index 5 -variable z index 5 - -units lj -atom_style atomic - -lattice fcc 0.8442 -Lattice spacing in x,y,z = 1.6795962 1.6795962 1.6795962 -region box block 0 $x 0 $y 0 $z -region box block 0 5 0 $y 0 $z -region box block 0 5 0 5 0 $z -region box block 0 5 0 5 0 5 -create_box 1 box -Created orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) - 1 by 1 by 1 MPI processor grid -create_atoms 1 box -Created 500 atoms - using lattice units in orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) - create_atoms CPU = 0.001 seconds -mass 1 1.0 - -velocity all create 1.44 87287 loop geom - -pair_style lj/cut 2.5 -pair_coeff 1 1 1.0 1.0 2.5 - -neighbor 0.3 bin -neigh_modify delay 0 every 1 check yes - -# NVE -fix 1 all nve -# NPT -#fix 1 all npt temp 1.0 1.0 0.1 iso 1.0 1.0 1.0 - -thermo_style custom step temp pe etotal press vol -thermo 1 - -run 5 - generated 0 of 0 mixed pair_coeff terms from geometric mixing rule -Neighbor list info ... - update every 1 steps, delay 0 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 2.8 - ghost atom cutoff = 2.8 - binsize = 1.4, bins = 6 6 6 - 1 neighbor lists, perpetual/occasional/extra = 1 0 0 - (1) pair lj/cut, perpetual - attributes: half, newton on - pair build: half/bin/atomonly/newton - stencil: half/bin/3d - bin: standard -Per MPI rank memory allocation (min/avg/max) = 3.144 | 3.144 | 3.144 Mbytes -Step Temp PotEng TotEng Press Volume - 0 1.44 -6.7733681 -4.6176881 -5.0221006 592.27671 - 1 1.4377309 -6.7699814 -4.6176981 -5.0007431 592.27671 - 2 1.430825 -6.7596844 -4.6177394 -4.9363501 592.27671 - 3 1.4189655 -6.7420029 -4.6178116 -4.8276957 592.27671 - 4 1.4016029 -6.7161132 -4.6179137 -4.6726332 592.27671 - 5 1.3779738 -6.6808361 -4.6180094 -4.468186 592.27671 -Loop time of 0.00427098 on 1 procs for 5 steps with 500 atoms - -Performance: 505739.085 tau/day, 1170.692 timesteps/s -73.9% CPU use with 1 MPI tasks x no OpenMP threads - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 0.0038665 | 0.0038665 | 0.0038665 | 0.0 | 90.53 -Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.0001297 | 0.0001297 | 0.0001297 | 0.0 | 3.04 -Output | 0.00014902 | 0.00014902 | 0.00014902 | 0.0 | 3.49 -Modify | 6.5249e-05 | 6.5249e-05 | 6.5249e-05 | 0.0 | 1.53 -Other | | 6.054e-05 | | | 1.42 - -Nlocal: 500 ave 500 max 500 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Nghost: 1956 ave 1956 max 1956 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Neighs: 19500 ave 19500 max 19500 min -Histogram: 1 0 0 0 0 0 0 0 0 0 - -Total # of neighbors = 19500 -Ave neighs/atom = 39 -Neighbor list builds = 0 -Dangerous builds = 0 -Total wall time: 0:00:00 diff --git a/examples/mdi/log.7Apr22.mdi.aimd.driver.mpi.g++.1 b/examples/mdi/log.7Apr22.mdi.aimd.driver.mpi.g++.1 deleted file mode 100644 index d817aed5a3..0000000000 --- a/examples/mdi/log.7Apr22.mdi.aimd.driver.mpi.g++.1 +++ /dev/null @@ -1,79 +0,0 @@ -LAMMPS (17 Feb 2022) -# 3d Lennard-Jones melt - MDI driver script - -variable x index 5 -variable y index 5 -variable z index 5 - -units lj -atom_style atomic - -lattice fcc 0.8442 -Lattice spacing in x,y,z = 1.6795962 1.6795962 1.6795962 -region box block 0 $x 0 $y 0 $z -region box block 0 5 0 $y 0 $z -region box block 0 5 0 5 0 $z -region box block 0 5 0 5 0 5 -create_box 1 box -Created orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) - 1 by 1 by 1 MPI processor grid -create_atoms 1 box -Created 500 atoms - using lattice units in orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) - create_atoms CPU = 0.001 seconds -mass 1 1.0 - -velocity all create 1.44 87287 loop geom - -neighbor 0.3 bin -neigh_modify delay 0 every 1 check yes - -# NVE -fix 1 all nve -# NPT -#fix 1 all npt temp 1.0 1.0 0.1 iso 1.0 1.0 1.0 - -fix 2 all mdi/aimd -fix_modify 2 energy yes virial yes - -thermo_style custom step temp pe etotal press vol -thermo 1 - -run 5 -WARNING: No pairwise cutoff or binsize set. Atom sorting therefore disabled. (../atom.cpp:2141) -WARNING: Communication cutoff is 0.0. No ghost atoms will be generated. Atoms may get lost. (../comm_brick.cpp:209) -Per MPI rank memory allocation (min/avg/max) = 2.297 | 2.297 | 2.297 Mbytes -Step Temp PotEng TotEng Press Volume - 0 1.44 -6.7733681 -4.6176881 -5.0221006 592.27671 - 1 1.4377309 -6.7699814 -4.6176981 -5.0007431 592.27671 - 2 1.430825 -6.7596844 -4.6177394 -4.9363501 592.27671 - 3 1.4189655 -6.7420029 -4.6178116 -4.8276957 592.27671 - 4 1.4016029 -6.7161132 -4.6179137 -4.6726332 592.27671 - 5 1.3779738 -6.6808361 -4.6180094 -4.468186 592.27671 -Loop time of 0.0029525 on 1 procs for 5 steps with 500 atoms - -Performance: 731582.413 tau/day, 1693.478 timesteps/s -99.3% CPU use with 1 MPI tasks x no OpenMP threads - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 0 | 0 | 0 | 0.0 | 0.00 -Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 1.2632e-05 | 1.2632e-05 | 1.2632e-05 | 0.0 | 0.43 -Output | 0.00010561 | 0.00010561 | 0.00010561 | 0.0 | 3.58 -Modify | 0.0028043 | 0.0028043 | 0.0028043 | 0.0 | 94.98 -Other | | 3e-05 | | | 1.02 - -Nlocal: 500 ave 500 max 500 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Nghost: 166 ave 166 max 166 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Neighs: 0 ave 0 max 0 min -Histogram: 1 0 0 0 0 0 0 0 0 0 - -Total # of neighbors = -1 -Ave neighs/atom = -0.002 -Neighbor list builds = 0 -Dangerous builds = 0 -Total wall time: 0:00:00 diff --git a/examples/mdi/log.7Apr22.mdi.aimd.driver.mpi.g++.3 b/examples/mdi/log.7Apr22.mdi.aimd.driver.mpi.g++.3 deleted file mode 100644 index eaf806cfc9..0000000000 --- a/examples/mdi/log.7Apr22.mdi.aimd.driver.mpi.g++.3 +++ /dev/null @@ -1,79 +0,0 @@ -LAMMPS (17 Feb 2022) -# 3d Lennard-Jones melt - MDI driver script - -variable x index 5 -variable y index 5 -variable z index 5 - -units lj -atom_style atomic - -lattice fcc 0.8442 -Lattice spacing in x,y,z = 1.6795962 1.6795962 1.6795962 -region box block 0 $x 0 $y 0 $z -region box block 0 5 0 $y 0 $z -region box block 0 5 0 5 0 $z -region box block 0 5 0 5 0 5 -create_box 1 box -Created orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) - 1 by 1 by 3 MPI processor grid -create_atoms 1 box -Created 500 atoms - using lattice units in orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) - create_atoms CPU = 0.001 seconds -mass 1 1.0 - -velocity all create 1.44 87287 loop geom - -neighbor 0.3 bin -neigh_modify delay 0 every 1 check yes - -# NVE -fix 1 all nve -# NPT -#fix 1 all npt temp 1.0 1.0 0.1 iso 1.0 1.0 1.0 - -fix 2 all mdi/aimd -fix_modify 2 energy yes virial yes - -thermo_style custom step temp pe etotal press vol -thermo 1 - -run 5 -WARNING: No pairwise cutoff or binsize set. Atom sorting therefore disabled. (../atom.cpp:2141) -WARNING: Communication cutoff is 0.0. No ghost atoms will be generated. Atoms may get lost. (../comm_brick.cpp:209) -Per MPI rank memory allocation (min/avg/max) = 2.297 | 2.297 | 2.297 Mbytes -Step Temp PotEng TotEng Press Volume - 0 1.44 -6.7733681 -4.6176881 -5.0221006 592.27671 - 1 1.4377309 -6.7699814 -4.6176981 -5.0007431 592.27671 - 2 1.430825 -6.7596844 -4.6177394 -4.9363501 592.27671 - 3 1.4189655 -6.7420029 -4.6178116 -4.8276957 592.27671 - 4 1.4016029 -6.7161132 -4.6179137 -4.6726332 592.27671 - 5 1.3779738 -6.6808361 -4.6180094 -4.468186 592.27671 -Loop time of 0.00315597 on 3 procs for 5 steps with 500 atoms - -Performance: 684416.574 tau/day, 1584.298 timesteps/s -99.5% CPU use with 3 MPI tasks x no OpenMP threads - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 0 | 0 | 0 | 0.0 | 0.00 -Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 1.769e-05 | 3.7059e-05 | 4.7808e-05 | 0.0 | 1.17 -Output | 0.00011556 | 0.00015516 | 0.00021954 | 0.0 | 4.92 -Modify | 0.002819 | 0.0028366 | 0.0028599 | 0.0 | 89.88 -Other | | 0.0001272 | | | 4.03 - -Nlocal: 166.667 ave 200 max 150 min -Histogram: 2 0 0 0 0 0 0 0 0 1 -Nghost: 55.3333 ave 92 max 32 min -Histogram: 1 1 0 0 0 0 0 0 0 1 -Neighs: 0 ave 0 max 0 min -Histogram: 3 0 0 0 0 0 0 0 0 0 - -Total # of neighbors = -3 -Ave neighs/atom = -0.006 -Neighbor list builds = 0 -Dangerous builds = 0 -Total wall time: 0:00:00 diff --git a/examples/mdi/log.7Apr22.mdi.aimd.driver.plugin.g++.1 b/examples/mdi/log.7Apr22.mdi.aimd.driver.plugin.g++.1 deleted file mode 100644 index dea662c157..0000000000 --- a/examples/mdi/log.7Apr22.mdi.aimd.driver.plugin.g++.1 +++ /dev/null @@ -1,80 +0,0 @@ -LAMMPS (17 Feb 2022) -# 3d Lennard-Jones melt - MDI driver script - -variable x index 5 -variable y index 5 -variable z index 5 - -units lj -atom_style atomic - -lattice fcc 0.8442 -Lattice spacing in x,y,z = 1.6795962 1.6795962 1.6795962 -region box block 0 $x 0 $y 0 $z -region box block 0 5 0 $y 0 $z -region box block 0 5 0 5 0 $z -region box block 0 5 0 5 0 5 -create_box 1 box -Created orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) - 1 by 1 by 1 MPI processor grid -create_atoms 1 box -Created 500 atoms - using lattice units in orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) - create_atoms CPU = 0.001 seconds -mass 1 1.0 - -velocity all create 1.44 87287 loop geom - -neighbor 0.3 bin -neigh_modify delay 0 every 1 check yes - -# NVE -fix 1 all nve -# NPT -#fix 1 all npt temp 1.0 1.0 0.1 iso 1.0 1.0 1.0 - -fix 2 all mdi/aimd plugin -fix_modify 2 energy yes virial yes - -thermo_style custom step temp pe etotal press vol -thermo 1 - -mdi plugin lammps mdi "-role ENGINE -name lammps -method LINK" infile in.aimd.engine extra "-log log.aimd.engine.plugin" command "run 5" -run 5 -WARNING: No pairwise cutoff or binsize set. Atom sorting therefore disabled. (../atom.cpp:2141) -WARNING: Communication cutoff is 0.0. No ghost atoms will be generated. Atoms may get lost. (../comm_brick.cpp:209) -Per MPI rank memory allocation (min/avg/max) = 2.297 | 2.297 | 2.297 Mbytes -Step Temp PotEng TotEng Press Volume - 0 1.44 -6.7733681 -4.6176881 -5.0221006 592.27671 - 1 1.4377309 -6.7699814 -4.6176981 -5.0007431 592.27671 - 2 1.430825 -6.7596844 -4.6177394 -4.9363501 592.27671 - 3 1.4189655 -6.7420029 -4.6178116 -4.8276957 592.27671 - 4 1.4016029 -6.7161132 -4.6179137 -4.6726332 592.27671 - 5 1.3779738 -6.6808361 -4.6180094 -4.468186 592.27671 -Loop time of 0.00396559 on 1 procs for 5 steps with 500 atoms - -Performance: 544685.246 tau/day, 1260.845 timesteps/s -98.3% CPU use with 1 MPI tasks x no OpenMP threads - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 0 | 0 | 0 | 0.0 | 0.00 -Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 1.5936e-05 | 1.5936e-05 | 1.5936e-05 | 0.0 | 0.40 -Output | 0.00011527 | 0.00011527 | 0.00011527 | 0.0 | 2.91 -Modify | 0.0038025 | 0.0038025 | 0.0038025 | 0.0 | 95.89 -Other | | 3.184e-05 | | | 0.80 - -Nlocal: 500 ave 500 max 500 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Nghost: 166 ave 166 max 166 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Neighs: 0 ave 0 max 0 min -Histogram: 1 0 0 0 0 0 0 0 0 0 - -Total # of neighbors = -1 -Ave neighs/atom = -0.002 -Neighbor list builds = 0 -Dangerous builds = 0 -Total wall time: 0:00:00 diff --git a/examples/mdi/log.7Apr22.mdi.aimd.driver.plugin.g++.3 b/examples/mdi/log.7Apr22.mdi.aimd.driver.plugin.g++.3 deleted file mode 100644 index ff9e2dd8f5..0000000000 --- a/examples/mdi/log.7Apr22.mdi.aimd.driver.plugin.g++.3 +++ /dev/null @@ -1,80 +0,0 @@ -LAMMPS (17 Feb 2022) -# 3d Lennard-Jones melt - MDI driver script - -variable x index 5 -variable y index 5 -variable z index 5 - -units lj -atom_style atomic - -lattice fcc 0.8442 -Lattice spacing in x,y,z = 1.6795962 1.6795962 1.6795962 -region box block 0 $x 0 $y 0 $z -region box block 0 5 0 $y 0 $z -region box block 0 5 0 5 0 $z -region box block 0 5 0 5 0 5 -create_box 1 box -Created orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) - 1 by 1 by 3 MPI processor grid -create_atoms 1 box -Created 500 atoms - using lattice units in orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) - create_atoms CPU = 0.001 seconds -mass 1 1.0 - -velocity all create 1.44 87287 loop geom - -neighbor 0.3 bin -neigh_modify delay 0 every 1 check yes - -# NVE -fix 1 all nve -# NPT -#fix 1 all npt temp 1.0 1.0 0.1 iso 1.0 1.0 1.0 - -fix 2 all mdi/aimd plugin -fix_modify 2 energy yes virial yes - -thermo_style custom step temp pe etotal press vol -thermo 1 - -mdi plugin lammps mdi "-role ENGINE -name lammps -method LINK" infile in.aimd.engine extra "-log log.aimd.engine.plugin" command "run 5" -run 5 -WARNING: No pairwise cutoff or binsize set. Atom sorting therefore disabled. (../atom.cpp:2141) -WARNING: Communication cutoff is 0.0. No ghost atoms will be generated. Atoms may get lost. (../comm_brick.cpp:209) -Per MPI rank memory allocation (min/avg/max) = 2.297 | 2.297 | 2.297 Mbytes -Step Temp PotEng TotEng Press Volume - 0 1.44 -6.7733681 -4.6176881 -5.0221006 592.27671 - 1 1.4377309 -6.7699814 -4.6176981 -5.0007431 592.27671 - 2 1.430825 -6.7596844 -4.6177394 -4.9363501 592.27671 - 3 1.4189655 -6.7420029 -4.6178116 -4.8276957 592.27671 - 4 1.4016029 -6.7161132 -4.6179137 -4.6726332 592.27671 - 5 1.3779738 -6.6808361 -4.6180094 -4.468186 592.27671 -Loop time of 0.00287217 on 3 procs for 5 steps with 500 atoms - -Performance: 752045.581 tau/day, 1740.846 timesteps/s -99.1% CPU use with 3 MPI tasks x no OpenMP threads - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 0 | 0 | 0 | 0.0 | 0.00 -Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 1.6368e-05 | 3.9139e-05 | 5.1029e-05 | 0.0 | 1.36 -Output | 9.6932e-05 | 0.00012081 | 0.00016442 | 0.0 | 4.21 -Modify | 0.0026109 | 0.0026258 | 0.0026494 | 0.0 | 91.42 -Other | | 8.637e-05 | | | 3.01 - -Nlocal: 166.667 ave 200 max 150 min -Histogram: 2 0 0 0 0 0 0 0 0 1 -Nghost: 55.3333 ave 92 max 32 min -Histogram: 1 1 0 0 0 0 0 0 0 1 -Neighs: 0 ave 0 max 0 min -Histogram: 3 0 0 0 0 0 0 0 0 0 - -Total # of neighbors = -3 -Ave neighs/atom = -0.006 -Neighbor list builds = 0 -Dangerous builds = 0 -Total wall time: 0:00:00 diff --git a/examples/mdi/log.7Apr22.mdi.aimd.driver.tcp.g++.1 b/examples/mdi/log.7Apr22.mdi.aimd.driver.tcp.g++.1 deleted file mode 100644 index 1ff358e269..0000000000 --- a/examples/mdi/log.7Apr22.mdi.aimd.driver.tcp.g++.1 +++ /dev/null @@ -1,79 +0,0 @@ -LAMMPS (17 Feb 2022) -# 3d Lennard-Jones melt - MDI driver script - -variable x index 5 -variable y index 5 -variable z index 5 - -units lj -atom_style atomic - -lattice fcc 0.8442 -Lattice spacing in x,y,z = 1.6795962 1.6795962 1.6795962 -region box block 0 $x 0 $y 0 $z -region box block 0 5 0 $y 0 $z -region box block 0 5 0 5 0 $z -region box block 0 5 0 5 0 5 -create_box 1 box -Created orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) - 1 by 1 by 1 MPI processor grid -create_atoms 1 box -Created 500 atoms - using lattice units in orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) - create_atoms CPU = 0.001 seconds -mass 1 1.0 - -velocity all create 1.44 87287 loop geom - -neighbor 0.3 bin -neigh_modify delay 0 every 1 check yes - -# NVE -fix 1 all nve -# NPT -#fix 1 all npt temp 1.0 1.0 0.1 iso 1.0 1.0 1.0 - -fix 2 all mdi/aimd -fix_modify 2 energy yes virial yes - -thermo_style custom step temp pe etotal press vol -thermo 1 - -run 5 -WARNING: No pairwise cutoff or binsize set. Atom sorting therefore disabled. (../atom.cpp:2141) -WARNING: Communication cutoff is 0.0. No ghost atoms will be generated. Atoms may get lost. (../comm_brick.cpp:209) -Per MPI rank memory allocation (min/avg/max) = 2.297 | 2.297 | 2.297 Mbytes -Step Temp PotEng TotEng Press Volume - 0 1.44 -6.7733681 -4.6176881 -5.0221006 592.27671 - 1 1.4377309 -6.7699814 -4.6176981 -5.0007431 592.27671 - 2 1.430825 -6.7596844 -4.6177394 -4.9363501 592.27671 - 3 1.4189655 -6.7420029 -4.6178116 -4.8276957 592.27671 - 4 1.4016029 -6.7161132 -4.6179137 -4.6726332 592.27671 - 5 1.3779738 -6.6808361 -4.6180094 -4.468186 592.27671 -Loop time of 1.20486 on 1 procs for 5 steps with 500 atoms - -Performance: 1792.736 tau/day, 4.150 timesteps/s -0.1% CPU use with 1 MPI tasks x no OpenMP threads - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 0 | 0 | 0 | 0.0 | 0.00 -Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 2.4487e-05 | 2.4487e-05 | 2.4487e-05 | 0.0 | 0.00 -Output | 0.00026499 | 0.00026499 | 0.00026499 | 0.0 | 0.02 -Modify | 1.2045 | 1.2045 | 1.2045 | 0.0 | 99.97 -Other | | 6.184e-05 | | | 0.01 - -Nlocal: 500 ave 500 max 500 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Nghost: 166 ave 166 max 166 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Neighs: 0 ave 0 max 0 min -Histogram: 1 0 0 0 0 0 0 0 0 0 - -Total # of neighbors = -1 -Ave neighs/atom = -0.002 -Neighbor list builds = 0 -Dangerous builds = 0 -Total wall time: 0:00:08 diff --git a/examples/mdi/log.7Apr22.mdi.aimd.driver.tcp.g++.3 b/examples/mdi/log.7Apr22.mdi.aimd.driver.tcp.g++.3 deleted file mode 100644 index 6abf6b3928..0000000000 --- a/examples/mdi/log.7Apr22.mdi.aimd.driver.tcp.g++.3 +++ /dev/null @@ -1,79 +0,0 @@ -LAMMPS (17 Feb 2022) -# 3d Lennard-Jones melt - MDI driver script - -variable x index 5 -variable y index 5 -variable z index 5 - -units lj -atom_style atomic - -lattice fcc 0.8442 -Lattice spacing in x,y,z = 1.6795962 1.6795962 1.6795962 -region box block 0 $x 0 $y 0 $z -region box block 0 5 0 $y 0 $z -region box block 0 5 0 5 0 $z -region box block 0 5 0 5 0 5 -create_box 1 box -Created orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) - 1 by 1 by 3 MPI processor grid -create_atoms 1 box -Created 500 atoms - using lattice units in orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) - create_atoms CPU = 0.001 seconds -mass 1 1.0 - -velocity all create 1.44 87287 loop geom - -neighbor 0.3 bin -neigh_modify delay 0 every 1 check yes - -# NVE -fix 1 all nve -# NPT -#fix 1 all npt temp 1.0 1.0 0.1 iso 1.0 1.0 1.0 - -fix 2 all mdi/aimd -fix_modify 2 energy yes virial yes - -thermo_style custom step temp pe etotal press vol -thermo 1 - -run 5 -WARNING: No pairwise cutoff or binsize set. Atom sorting therefore disabled. (../atom.cpp:2141) -WARNING: Communication cutoff is 0.0. No ghost atoms will be generated. Atoms may get lost. (../comm_brick.cpp:209) -Per MPI rank memory allocation (min/avg/max) = 2.297 | 2.297 | 2.297 Mbytes -Step Temp PotEng TotEng Press Volume - 0 1.44 -6.7733681 -4.6176881 -5.0221006 592.27671 - 1 1.4377309 -6.7699814 -4.6176981 -5.0007431 592.27671 - 2 1.430825 -6.7596844 -4.6177394 -4.9363501 592.27671 - 3 1.4189655 -6.7420029 -4.6178116 -4.8276957 592.27671 - 4 1.4016029 -6.7161132 -4.6179137 -4.6726332 592.27671 - 5 1.3779738 -6.6808361 -4.6180094 -4.468186 592.27671 -Loop time of 1.19983 on 3 procs for 5 steps with 500 atoms - -Performance: 1800.259 tau/day, 4.167 timesteps/s -66.7% CPU use with 3 MPI tasks x no OpenMP threads - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 0 | 0 | 0 | 0.0 | 0.00 -Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 4.604e-06 | 4.8462e-05 | 7.527e-05 | 0.0 | 0.00 -Output | 0.00015266 | 0.00020593 | 0.00031177 | 0.0 | 0.02 -Modify | 1.1993 | 1.1994 | 1.1994 | 0.0 | 99.96 -Other | | 0.0002123 | | | 0.02 - -Nlocal: 166.667 ave 200 max 150 min -Histogram: 2 0 0 0 0 0 0 0 0 1 -Nghost: 55.3333 ave 92 max 32 min -Histogram: 1 1 0 0 0 0 0 0 0 1 -Neighs: 0 ave 0 max 0 min -Histogram: 3 0 0 0 0 0 0 0 0 0 - -Total # of neighbors = -3 -Ave neighs/atom = -0.006 -Neighbor list builds = 0 -Dangerous builds = 0 -Total wall time: 0:00:08 diff --git a/examples/mdi/log.7Apr22.mdi.aimd.engine.mpi.g++.1 b/examples/mdi/log.7Apr22.mdi.aimd.engine.mpi.g++.1 deleted file mode 100644 index 615dae0578..0000000000 --- a/examples/mdi/log.7Apr22.mdi.aimd.engine.mpi.g++.1 +++ /dev/null @@ -1,55 +0,0 @@ -LAMMPS (17 Feb 2022) -# 3d Lennard-Jones melt - MDI engine script - -variable x index 5 -variable y index 5 -variable z index 5 - -units lj -atom_style atomic - -lattice fcc 0.8442 -Lattice spacing in x,y,z = 1.6795962 1.6795962 1.6795962 -region box block 0 $x 0 $y 0 $z -region box block 0 5 0 $y 0 $z -region box block 0 5 0 5 0 $z -region box block 0 5 0 5 0 5 -create_box 1 box -Created orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) - 1 by 1 by 1 MPI processor grid -create_atoms 1 box -Created 500 atoms - using lattice units in orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) - create_atoms CPU = 0.001 seconds -mass 1 1.0 - -pair_style lj/cut 2.5 -pair_coeff 1 1 1.0 1.0 2.5 - -neighbor 0.3 bin -neigh_modify delay 0 every 1 check yes - -mdi engine -WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) - generated 0 of 0 mixed pair_coeff terms from geometric mixing rule -Neighbor list info ... - update every 1 steps, delay 0 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 2.8 - ghost atom cutoff = 2.8 - binsize = 1.4, bins = 6 6 6 - 1 neighbor lists, perpetual/occasional/extra = 1 0 0 - (1) pair lj/cut, perpetual - attributes: half, newton on - pair build: half/bin/atomonly/newton - stencil: half/bin/3d - bin: standard -Per MPI rank memory allocation (min/avg/max) = 3.144 | 3.144 | 3.144 Mbytes -Step Temp E_pair E_mol TotEng Press - 0 0 -6.7733681 0 -6.7733681 -6.2353173 - 1 0 -6.7699814 0 -6.7699814 -6.2120481 - 2 0 -6.7596844 0 -6.7596844 -6.1418368 - 3 0 -6.7420029 0 -6.7420029 -6.0231905 - 4 0 -6.7161132 0 -6.7161132 -5.8534999 - 5 0 -6.6808361 0 -6.6808361 -5.6291449 -Total wall time: 0:00:00 diff --git a/examples/mdi/log.7Apr22.mdi.aimd.engine.mpi.g++.4 b/examples/mdi/log.7Apr22.mdi.aimd.engine.mpi.g++.4 deleted file mode 100644 index 88d5c66892..0000000000 --- a/examples/mdi/log.7Apr22.mdi.aimd.engine.mpi.g++.4 +++ /dev/null @@ -1,55 +0,0 @@ -LAMMPS (17 Feb 2022) -# 3d Lennard-Jones melt - MDI engine script - -variable x index 5 -variable y index 5 -variable z index 5 - -units lj -atom_style atomic - -lattice fcc 0.8442 -Lattice spacing in x,y,z = 1.6795962 1.6795962 1.6795962 -region box block 0 $x 0 $y 0 $z -region box block 0 5 0 $y 0 $z -region box block 0 5 0 5 0 $z -region box block 0 5 0 5 0 5 -create_box 1 box -Created orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) - 1 by 2 by 2 MPI processor grid -create_atoms 1 box -Created 500 atoms - using lattice units in orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) - create_atoms CPU = 0.001 seconds -mass 1 1.0 - -pair_style lj/cut 2.5 -pair_coeff 1 1 1.0 1.0 2.5 - -neighbor 0.3 bin -neigh_modify delay 0 every 1 check yes - -mdi engine -WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) - generated 0 of 0 mixed pair_coeff terms from geometric mixing rule -Neighbor list info ... - update every 1 steps, delay 0 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 2.8 - ghost atom cutoff = 2.8 - binsize = 1.4, bins = 6 6 6 - 1 neighbor lists, perpetual/occasional/extra = 1 0 0 - (1) pair lj/cut, perpetual - attributes: half, newton on - pair build: half/bin/atomonly/newton - stencil: half/bin/3d - bin: standard -Per MPI rank memory allocation (min/avg/max) = 3.109 | 3.109 | 3.109 Mbytes -Step Temp E_pair E_mol TotEng Press - 0 0 -6.7733681 0 -6.7733681 -6.2353173 - 1 0 -6.7699814 0 -6.7699814 -6.2120481 - 2 0 -6.7596844 0 -6.7596844 -6.1418368 - 3 0 -6.7420029 0 -6.7420029 -6.0231905 - 4 0 -6.7161132 0 -6.7161132 -5.8534999 - 5 0 -6.6808361 0 -6.6808361 -5.6291449 -Total wall time: 0:00:00 diff --git a/examples/mdi/log.7Apr22.mdi.aimd.engine.plugin.g++.1 b/examples/mdi/log.7Apr22.mdi.aimd.engine.plugin.g++.1 deleted file mode 100644 index 615dae0578..0000000000 --- a/examples/mdi/log.7Apr22.mdi.aimd.engine.plugin.g++.1 +++ /dev/null @@ -1,55 +0,0 @@ -LAMMPS (17 Feb 2022) -# 3d Lennard-Jones melt - MDI engine script - -variable x index 5 -variable y index 5 -variable z index 5 - -units lj -atom_style atomic - -lattice fcc 0.8442 -Lattice spacing in x,y,z = 1.6795962 1.6795962 1.6795962 -region box block 0 $x 0 $y 0 $z -region box block 0 5 0 $y 0 $z -region box block 0 5 0 5 0 $z -region box block 0 5 0 5 0 5 -create_box 1 box -Created orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) - 1 by 1 by 1 MPI processor grid -create_atoms 1 box -Created 500 atoms - using lattice units in orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) - create_atoms CPU = 0.001 seconds -mass 1 1.0 - -pair_style lj/cut 2.5 -pair_coeff 1 1 1.0 1.0 2.5 - -neighbor 0.3 bin -neigh_modify delay 0 every 1 check yes - -mdi engine -WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) - generated 0 of 0 mixed pair_coeff terms from geometric mixing rule -Neighbor list info ... - update every 1 steps, delay 0 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 2.8 - ghost atom cutoff = 2.8 - binsize = 1.4, bins = 6 6 6 - 1 neighbor lists, perpetual/occasional/extra = 1 0 0 - (1) pair lj/cut, perpetual - attributes: half, newton on - pair build: half/bin/atomonly/newton - stencil: half/bin/3d - bin: standard -Per MPI rank memory allocation (min/avg/max) = 3.144 | 3.144 | 3.144 Mbytes -Step Temp E_pair E_mol TotEng Press - 0 0 -6.7733681 0 -6.7733681 -6.2353173 - 1 0 -6.7699814 0 -6.7699814 -6.2120481 - 2 0 -6.7596844 0 -6.7596844 -6.1418368 - 3 0 -6.7420029 0 -6.7420029 -6.0231905 - 4 0 -6.7161132 0 -6.7161132 -5.8534999 - 5 0 -6.6808361 0 -6.6808361 -5.6291449 -Total wall time: 0:00:00 diff --git a/examples/mdi/log.7Apr22.mdi.aimd.engine.plugin.g++.3 b/examples/mdi/log.7Apr22.mdi.aimd.engine.plugin.g++.3 deleted file mode 100644 index fb8034972f..0000000000 --- a/examples/mdi/log.7Apr22.mdi.aimd.engine.plugin.g++.3 +++ /dev/null @@ -1,55 +0,0 @@ -LAMMPS (17 Feb 2022) -# 3d Lennard-Jones melt - MDI engine script - -variable x index 5 -variable y index 5 -variable z index 5 - -units lj -atom_style atomic - -lattice fcc 0.8442 -Lattice spacing in x,y,z = 1.6795962 1.6795962 1.6795962 -region box block 0 $x 0 $y 0 $z -region box block 0 5 0 $y 0 $z -region box block 0 5 0 5 0 $z -region box block 0 5 0 5 0 5 -create_box 1 box -Created orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) - 1 by 1 by 3 MPI processor grid -create_atoms 1 box -Created 500 atoms - using lattice units in orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) - create_atoms CPU = 0.001 seconds -mass 1 1.0 - -pair_style lj/cut 2.5 -pair_coeff 1 1 1.0 1.0 2.5 - -neighbor 0.3 bin -neigh_modify delay 0 every 1 check yes - -mdi engine -WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) - generated 0 of 0 mixed pair_coeff terms from geometric mixing rule -Neighbor list info ... - update every 1 steps, delay 0 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 2.8 - ghost atom cutoff = 2.8 - binsize = 1.4, bins = 6 6 6 - 1 neighbor lists, perpetual/occasional/extra = 1 0 0 - (1) pair lj/cut, perpetual - attributes: half, newton on - pair build: half/bin/atomonly/newton - stencil: half/bin/3d - bin: standard -Per MPI rank memory allocation (min/avg/max) = 3.124 | 3.13 | 3.133 Mbytes -Step Temp E_pair E_mol TotEng Press - 0 0 -6.7733681 0 -6.7733681 -6.2353173 - 1 0 -6.7699814 0 -6.7699814 -6.2120481 - 2 0 -6.7596844 0 -6.7596844 -6.1418368 - 3 0 -6.7420029 0 -6.7420029 -6.0231905 - 4 0 -6.7161132 0 -6.7161132 -5.8534999 - 5 0 -6.6808361 0 -6.6808361 -5.6291449 -Total wall time: 0:00:00 diff --git a/examples/mdi/log.7Apr22.mdi.aimd.engine.tcp.g++.1 b/examples/mdi/log.7Apr22.mdi.aimd.engine.tcp.g++.1 deleted file mode 100644 index 72becb2bba..0000000000 --- a/examples/mdi/log.7Apr22.mdi.aimd.engine.tcp.g++.1 +++ /dev/null @@ -1,55 +0,0 @@ -LAMMPS (17 Feb 2022) -# 3d Lennard-Jones melt - MDI engine script - -variable x index 5 -variable y index 5 -variable z index 5 - -units lj -atom_style atomic - -lattice fcc 0.8442 -Lattice spacing in x,y,z = 1.6795962 1.6795962 1.6795962 -region box block 0 $x 0 $y 0 $z -region box block 0 5 0 $y 0 $z -region box block 0 5 0 5 0 $z -region box block 0 5 0 5 0 5 -create_box 1 box -Created orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) - 1 by 1 by 1 MPI processor grid -create_atoms 1 box -Created 500 atoms - using lattice units in orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) - create_atoms CPU = 0.001 seconds -mass 1 1.0 - -pair_style lj/cut 2.5 -pair_coeff 1 1 1.0 1.0 2.5 - -neighbor 0.3 bin -neigh_modify delay 0 every 1 check yes - -mdi engine -WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) - generated 0 of 0 mixed pair_coeff terms from geometric mixing rule -Neighbor list info ... - update every 1 steps, delay 0 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 2.8 - ghost atom cutoff = 2.8 - binsize = 1.4, bins = 6 6 6 - 1 neighbor lists, perpetual/occasional/extra = 1 0 0 - (1) pair lj/cut, perpetual - attributes: half, newton on - pair build: half/bin/atomonly/newton - stencil: half/bin/3d - bin: standard -Per MPI rank memory allocation (min/avg/max) = 3.144 | 3.144 | 3.144 Mbytes -Step Temp E_pair E_mol TotEng Press - 0 0 -6.7733681 0 -6.7733681 -6.2353173 - 1 0 -6.7699814 0 -6.7699814 -6.2120481 - 2 0 -6.7596844 0 -6.7596844 -6.1418368 - 3 0 -6.7420029 0 -6.7420029 -6.0231905 - 4 0 -6.7161132 0 -6.7161132 -5.8534999 - 5 0 -6.6808361 0 -6.6808361 -5.6291449 -Total wall time: 0:00:01 diff --git a/examples/mdi/log.7Apr22.mdi.aimd.engine.tcp.g++.4 b/examples/mdi/log.7Apr22.mdi.aimd.engine.tcp.g++.4 deleted file mode 100644 index 3154bd0b27..0000000000 --- a/examples/mdi/log.7Apr22.mdi.aimd.engine.tcp.g++.4 +++ /dev/null @@ -1,55 +0,0 @@ -LAMMPS (17 Feb 2022) -# 3d Lennard-Jones melt - MDI engine script - -variable x index 5 -variable y index 5 -variable z index 5 - -units lj -atom_style atomic - -lattice fcc 0.8442 -Lattice spacing in x,y,z = 1.6795962 1.6795962 1.6795962 -region box block 0 $x 0 $y 0 $z -region box block 0 5 0 $y 0 $z -region box block 0 5 0 5 0 $z -region box block 0 5 0 5 0 5 -create_box 1 box -Created orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) - 1 by 2 by 2 MPI processor grid -create_atoms 1 box -Created 500 atoms - using lattice units in orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) - create_atoms CPU = 0.001 seconds -mass 1 1.0 - -pair_style lj/cut 2.5 -pair_coeff 1 1 1.0 1.0 2.5 - -neighbor 0.3 bin -neigh_modify delay 0 every 1 check yes - -mdi engine -WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) - generated 0 of 0 mixed pair_coeff terms from geometric mixing rule -Neighbor list info ... - update every 1 steps, delay 0 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 2.8 - ghost atom cutoff = 2.8 - binsize = 1.4, bins = 6 6 6 - 1 neighbor lists, perpetual/occasional/extra = 1 0 0 - (1) pair lj/cut, perpetual - attributes: half, newton on - pair build: half/bin/atomonly/newton - stencil: half/bin/3d - bin: standard -Per MPI rank memory allocation (min/avg/max) = 3.109 | 3.109 | 3.109 Mbytes -Step Temp E_pair E_mol TotEng Press - 0 0 -6.7733681 0 -6.7733681 -6.2353173 - 1 0 -6.7699814 0 -6.7699814 -6.2120481 - 2 0 -6.7596844 0 -6.7596844 -6.1418368 - 3 0 -6.7420029 0 -6.7420029 -6.0231905 - 4 0 -6.7161132 0 -6.7161132 -5.8534999 - 5 0 -6.6808361 0 -6.6808361 -5.6291449 -Total wall time: 0:00:01 diff --git a/examples/mdi/log.7Apr22.mdi.aimdpy.driver.mpi.g++.1 b/examples/mdi/log.7Apr22.mdi.aimdpy.driver.mpi.g++.1 deleted file mode 100644 index 741e8a1dfe..0000000000 --- a/examples/mdi/log.7Apr22.mdi.aimdpy.driver.mpi.g++.1 +++ /dev/null @@ -1,5 +0,0 @@ -Step 1: MM energy 2.15228, QM energy -6.76998, Total energy -4.6177 -Step 2: MM energy 2.14195, QM energy -6.75968, Total energy -4.61774 -Step 3: MM energy 2.12419, QM energy -6.742, Total energy -4.61781 -Step 4: MM energy 2.0982, QM energy -6.71611, Total energy -4.61791 -Step 5: MM energy 2.06283, QM energy -6.68084, Total energy -4.61801 diff --git a/examples/mdi/log.7Apr22.mdi.aimdpy.driver.mpi.g++.2 b/examples/mdi/log.7Apr22.mdi.aimdpy.driver.mpi.g++.2 deleted file mode 100644 index 741e8a1dfe..0000000000 --- a/examples/mdi/log.7Apr22.mdi.aimdpy.driver.mpi.g++.2 +++ /dev/null @@ -1,5 +0,0 @@ -Step 1: MM energy 2.15228, QM energy -6.76998, Total energy -4.6177 -Step 2: MM energy 2.14195, QM energy -6.75968, Total energy -4.61774 -Step 3: MM energy 2.12419, QM energy -6.742, Total energy -4.61781 -Step 4: MM energy 2.0982, QM energy -6.71611, Total energy -4.61791 -Step 5: MM energy 2.06283, QM energy -6.68084, Total energy -4.61801 diff --git a/examples/mdi/log.7Apr22.mdi.aimdpy.driver.tcp.g++.1 b/examples/mdi/log.7Apr22.mdi.aimdpy.driver.tcp.g++.1 deleted file mode 100644 index 2205a0f051..0000000000 --- a/examples/mdi/log.7Apr22.mdi.aimdpy.driver.tcp.g++.1 +++ /dev/null @@ -1,6 +0,0 @@ -Step 0: MM energy 2.15568, QM energy -6.77337, Total energy -4.61769 -Step 1: MM energy 2.15228, QM energy -6.76998, Total energy -4.6177 -Step 2: MM energy 2.14195, QM energy -6.75968, Total energy -4.61774 -Step 3: MM energy 2.12419, QM energy -6.742, Total energy -4.61781 -Step 4: MM energy 2.0982, QM energy -6.71611, Total energy -4.61791 -Step 5: MM energy 2.06283, QM energy -6.68084, Total energy -4.61801 diff --git a/examples/mdi/log.7Apr22.mdi.aimdpy.driver.tcp.g++.2 b/examples/mdi/log.7Apr22.mdi.aimdpy.driver.tcp.g++.2 deleted file mode 100644 index 2205a0f051..0000000000 --- a/examples/mdi/log.7Apr22.mdi.aimdpy.driver.tcp.g++.2 +++ /dev/null @@ -1,6 +0,0 @@ -Step 0: MM energy 2.15568, QM energy -6.77337, Total energy -4.61769 -Step 1: MM energy 2.15228, QM energy -6.76998, Total energy -4.6177 -Step 2: MM energy 2.14195, QM energy -6.75968, Total energy -4.61774 -Step 3: MM energy 2.12419, QM energy -6.742, Total energy -4.61781 -Step 4: MM energy 2.0982, QM energy -6.71611, Total energy -4.61791 -Step 5: MM energy 2.06283, QM energy -6.68084, Total energy -4.61801 diff --git a/examples/mdi/log.7Apr22.mdi.aimdpy.mm.mpi.g++.1 b/examples/mdi/log.7Apr22.mdi.aimdpy.mm.mpi.g++.1 deleted file mode 100644 index 55825ab30a..0000000000 --- a/examples/mdi/log.7Apr22.mdi.aimdpy.mm.mpi.g++.1 +++ /dev/null @@ -1,44 +0,0 @@ -LAMMPS (17 Feb 2022) -# 3d Lennard-Jones melt - LAMMPS as MM engine for aimd_driver.py - -variable x index 5 -variable y index 5 -variable z index 5 - -units lj -atom_style atomic - -lattice fcc 0.8442 -Lattice spacing in x,y,z = 1.6795962 1.6795962 1.6795962 -region box block 0 $x 0 $y 0 $z -region box block 0 5 0 $y 0 $z -region box block 0 5 0 5 0 $z -region box block 0 5 0 5 0 5 -create_box 1 box -Created orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) - 1 by 1 by 1 MPI processor grid -create_atoms 1 box -Created 500 atoms - using lattice units in orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) - create_atoms CPU = 0.001 seconds -mass 1 1.0 - -velocity all create 1.44 87287 loop geom - -neighbor 0.3 bin -neigh_modify delay 0 every 1 check yes - -fix 1 all nve - -mdi engine -WARNING: No pairwise cutoff or binsize set. Atom sorting therefore disabled. (../atom.cpp:2141) -WARNING: Communication cutoff is 0.0. No ghost atoms will be generated. Atoms may get lost. (../comm_brick.cpp:209) -Per MPI rank memory allocation (min/avg/max) = 2.297 | 2.297 | 2.297 Mbytes -Step Temp E_pair E_mol TotEng Press - 0 1.44 0 0 2.15568 1.2132167 - 1 1.4377309 0 0 2.1522832 1.211305 - 2 1.430825 0 0 2.141945 1.2054866 - 3 1.4189655 0 0 2.1241913 1.1954949 - 4 1.4016029 0 0 2.0981995 1.1808667 - 5 1.3779738 0 0 2.0628267 1.1609589 -Total wall time: 0:00:00 diff --git a/examples/mdi/log.7Apr22.mdi.aimdpy.mm.mpi.g++.2 b/examples/mdi/log.7Apr22.mdi.aimdpy.mm.mpi.g++.2 deleted file mode 100644 index 4c636b8486..0000000000 --- a/examples/mdi/log.7Apr22.mdi.aimdpy.mm.mpi.g++.2 +++ /dev/null @@ -1,44 +0,0 @@ -LAMMPS (17 Feb 2022) -# 3d Lennard-Jones melt - LAMMPS as MM engine for aimd_driver.py - -variable x index 5 -variable y index 5 -variable z index 5 - -units lj -atom_style atomic - -lattice fcc 0.8442 -Lattice spacing in x,y,z = 1.6795962 1.6795962 1.6795962 -region box block 0 $x 0 $y 0 $z -region box block 0 5 0 $y 0 $z -region box block 0 5 0 5 0 $z -region box block 0 5 0 5 0 5 -create_box 1 box -Created orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) - 1 by 1 by 2 MPI processor grid -create_atoms 1 box -Created 500 atoms - using lattice units in orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) - create_atoms CPU = 0.001 seconds -mass 1 1.0 - -velocity all create 1.44 87287 loop geom - -neighbor 0.3 bin -neigh_modify delay 0 every 1 check yes - -fix 1 all nve - -mdi engine -WARNING: No pairwise cutoff or binsize set. Atom sorting therefore disabled. (../atom.cpp:2141) -WARNING: Communication cutoff is 0.0. No ghost atoms will be generated. Atoms may get lost. (../comm_brick.cpp:209) -Per MPI rank memory allocation (min/avg/max) = 2.297 | 2.297 | 2.297 Mbytes -Step Temp E_pair E_mol TotEng Press - 0 1.44 0 0 2.15568 1.2132167 - 1 1.4377309 0 0 2.1522832 1.211305 - 2 1.430825 0 0 2.141945 1.2054866 - 3 1.4189655 0 0 2.1241913 1.1954949 - 4 1.4016029 0 0 2.0981995 1.1808667 - 5 1.3779738 0 0 2.0628267 1.1609589 -Total wall time: 0:00:00 diff --git a/examples/mdi/log.7Apr22.mdi.aimdpy.mm.tcp.g++.1 b/examples/mdi/log.7Apr22.mdi.aimdpy.mm.tcp.g++.1 deleted file mode 100644 index 7eb94ac4c6..0000000000 --- a/examples/mdi/log.7Apr22.mdi.aimdpy.mm.tcp.g++.1 +++ /dev/null @@ -1,44 +0,0 @@ -LAMMPS (17 Feb 2022) -# 3d Lennard-Jones melt - LAMMPS as MM engine for aimd_driver.py - -variable x index 5 -variable y index 5 -variable z index 5 - -units lj -atom_style atomic - -lattice fcc 0.8442 -Lattice spacing in x,y,z = 1.6795962 1.6795962 1.6795962 -region box block 0 $x 0 $y 0 $z -region box block 0 5 0 $y 0 $z -region box block 0 5 0 5 0 $z -region box block 0 5 0 5 0 5 -create_box 1 box -Created orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) - 1 by 1 by 1 MPI processor grid -create_atoms 1 box -Created 500 atoms - using lattice units in orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) - create_atoms CPU = 0.001 seconds -mass 1 1.0 - -velocity all create 1.44 87287 loop geom - -neighbor 0.3 bin -neigh_modify delay 0 every 1 check yes - -fix 1 all nve - -mdi engine -WARNING: No pairwise cutoff or binsize set. Atom sorting therefore disabled. (../atom.cpp:2141) -WARNING: Communication cutoff is 0.0. No ghost atoms will be generated. Atoms may get lost. (../comm_brick.cpp:209) -Per MPI rank memory allocation (min/avg/max) = 2.297 | 2.297 | 2.297 Mbytes -Step Temp E_pair E_mol TotEng Press - 0 1.44 0 0 2.15568 1.2132167 - 1 1.4377309 0 0 2.1522832 1.211305 - 2 1.430825 0 0 2.141945 1.2054866 - 3 1.4189655 0 0 2.1241913 1.1954949 - 4 1.4016029 0 0 2.0981995 1.1808667 - 5 1.3779738 0 0 2.0628267 1.1609589 -Total wall time: 0:00:11 diff --git a/examples/mdi/log.7Apr22.mdi.aimdpy.mm.tcp.g++.2 b/examples/mdi/log.7Apr22.mdi.aimdpy.mm.tcp.g++.2 deleted file mode 100644 index 6d253ee790..0000000000 --- a/examples/mdi/log.7Apr22.mdi.aimdpy.mm.tcp.g++.2 +++ /dev/null @@ -1,44 +0,0 @@ -LAMMPS (17 Feb 2022) -# 3d Lennard-Jones melt - LAMMPS as MM engine for aimd_driver.py - -variable x index 5 -variable y index 5 -variable z index 5 - -units lj -atom_style atomic - -lattice fcc 0.8442 -Lattice spacing in x,y,z = 1.6795962 1.6795962 1.6795962 -region box block 0 $x 0 $y 0 $z -region box block 0 5 0 $y 0 $z -region box block 0 5 0 5 0 $z -region box block 0 5 0 5 0 5 -create_box 1 box -Created orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) - 1 by 1 by 2 MPI processor grid -create_atoms 1 box -Created 500 atoms - using lattice units in orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) - create_atoms CPU = 0.001 seconds -mass 1 1.0 - -velocity all create 1.44 87287 loop geom - -neighbor 0.3 bin -neigh_modify delay 0 every 1 check yes - -fix 1 all nve - -mdi engine -WARNING: No pairwise cutoff or binsize set. Atom sorting therefore disabled. (../atom.cpp:2141) -WARNING: Communication cutoff is 0.0. No ghost atoms will be generated. Atoms may get lost. (../comm_brick.cpp:209) -Per MPI rank memory allocation (min/avg/max) = 2.297 | 2.297 | 2.297 Mbytes -Step Temp E_pair E_mol TotEng Press - 0 1.44 0 0 2.15568 1.2132167 - 1 1.4377309 0 0 2.1522832 1.211305 - 2 1.430825 0 0 2.141945 1.2054866 - 3 1.4189655 0 0 2.1241913 1.1954949 - 4 1.4016029 0 0 2.0981995 1.1808667 - 5 1.3779738 0 0 2.0628267 1.1609589 -Total wall time: 0:00:11 diff --git a/examples/mdi/log.7Apr22.mdi.aimdpy.qm.mpi.g++.1 b/examples/mdi/log.7Apr22.mdi.aimdpy.qm.mpi.g++.1 deleted file mode 100644 index e75a12c948..0000000000 --- a/examples/mdi/log.7Apr22.mdi.aimdpy.qm.mpi.g++.1 +++ /dev/null @@ -1,55 +0,0 @@ -LAMMPS (17 Feb 2022) -# 3d Lennard-Jones melt - LAMMPS as surrogate QM engine for aimd_driver.py - -variable x index 5 -variable y index 5 -variable z index 5 - -units lj -atom_style atomic - -lattice fcc 0.8442 -Lattice spacing in x,y,z = 1.6795962 1.6795962 1.6795962 -region box block 0 $x 0 $y 0 $z -region box block 0 5 0 $y 0 $z -region box block 0 5 0 5 0 $z -region box block 0 5 0 5 0 5 -create_box 1 box -Created orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) - 1 by 1 by 1 MPI processor grid -create_atoms 1 box -Created 500 atoms - using lattice units in orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) - create_atoms CPU = 0.001 seconds -mass 1 1.0 - -pair_style lj/cut 2.5 -pair_coeff 1 1 1.0 1.0 2.5 - -neighbor 0.3 bin -neigh_modify delay 0 every 1 check yes - -mdi engine -WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) - generated 0 of 0 mixed pair_coeff terms from geometric mixing rule -Neighbor list info ... - update every 1 steps, delay 0 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 2.8 - ghost atom cutoff = 2.8 - binsize = 1.4, bins = 6 6 6 - 1 neighbor lists, perpetual/occasional/extra = 1 0 0 - (1) pair lj/cut, perpetual - attributes: half, newton on - pair build: half/bin/atomonly/newton - stencil: half/bin/3d - bin: standard -Per MPI rank memory allocation (min/avg/max) = 3.144 | 3.144 | 3.144 Mbytes -Step Temp E_pair E_mol TotEng Press - 0 0 -6.7733681 0 -6.7733681 -6.2353173 - 1 0 -6.7699814 0 -6.7699814 -6.2120481 - 2 0 -6.7596844 0 -6.7596844 -6.1418368 - 3 0 -6.7420029 0 -6.7420029 -6.0231905 - 4 0 -6.7161132 0 -6.7161132 -5.8534999 - 5 0 -6.6808361 0 -6.6808361 -5.6291449 -Total wall time: 0:00:00 diff --git a/examples/mdi/log.7Apr22.mdi.aimdpy.qm.mpi.g++.3 b/examples/mdi/log.7Apr22.mdi.aimdpy.qm.mpi.g++.3 deleted file mode 100644 index 5d6702100c..0000000000 --- a/examples/mdi/log.7Apr22.mdi.aimdpy.qm.mpi.g++.3 +++ /dev/null @@ -1,55 +0,0 @@ -LAMMPS (17 Feb 2022) -# 3d Lennard-Jones melt - LAMMPS as surrogate QM engine for aimd_driver.py - -variable x index 5 -variable y index 5 -variable z index 5 - -units lj -atom_style atomic - -lattice fcc 0.8442 -Lattice spacing in x,y,z = 1.6795962 1.6795962 1.6795962 -region box block 0 $x 0 $y 0 $z -region box block 0 5 0 $y 0 $z -region box block 0 5 0 5 0 $z -region box block 0 5 0 5 0 5 -create_box 1 box -Created orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) - 1 by 1 by 3 MPI processor grid -create_atoms 1 box -Created 500 atoms - using lattice units in orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) - create_atoms CPU = 0.001 seconds -mass 1 1.0 - -pair_style lj/cut 2.5 -pair_coeff 1 1 1.0 1.0 2.5 - -neighbor 0.3 bin -neigh_modify delay 0 every 1 check yes - -mdi engine -WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) - generated 0 of 0 mixed pair_coeff terms from geometric mixing rule -Neighbor list info ... - update every 1 steps, delay 0 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 2.8 - ghost atom cutoff = 2.8 - binsize = 1.4, bins = 6 6 6 - 1 neighbor lists, perpetual/occasional/extra = 1 0 0 - (1) pair lj/cut, perpetual - attributes: half, newton on - pair build: half/bin/atomonly/newton - stencil: half/bin/3d - bin: standard -Per MPI rank memory allocation (min/avg/max) = 3.124 | 3.13 | 3.133 Mbytes -Step Temp E_pair E_mol TotEng Press - 0 0 -6.7733681 0 -6.7733681 -6.2353173 - 1 0 -6.7699814 0 -6.7699814 -6.2120481 - 2 0 -6.7596844 0 -6.7596844 -6.1418368 - 3 0 -6.7420029 0 -6.7420029 -6.0231905 - 4 0 -6.7161132 0 -6.7161132 -5.8534999 - 5 0 -6.6808361 0 -6.6808361 -5.6291449 -Total wall time: 0:00:00 diff --git a/examples/mdi/log.7Apr22.mdi.aimdpy.qm.tcp.g++.1 b/examples/mdi/log.7Apr22.mdi.aimdpy.qm.tcp.g++.1 deleted file mode 100644 index 8750392def..0000000000 --- a/examples/mdi/log.7Apr22.mdi.aimdpy.qm.tcp.g++.1 +++ /dev/null @@ -1,55 +0,0 @@ -LAMMPS (17 Feb 2022) -# 3d Lennard-Jones melt - LAMMPS as surrogate QM engine for aimd_driver.py - -variable x index 5 -variable y index 5 -variable z index 5 - -units lj -atom_style atomic - -lattice fcc 0.8442 -Lattice spacing in x,y,z = 1.6795962 1.6795962 1.6795962 -region box block 0 $x 0 $y 0 $z -region box block 0 5 0 $y 0 $z -region box block 0 5 0 5 0 $z -region box block 0 5 0 5 0 5 -create_box 1 box -Created orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) - 1 by 1 by 1 MPI processor grid -create_atoms 1 box -Created 500 atoms - using lattice units in orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) - create_atoms CPU = 0.001 seconds -mass 1 1.0 - -pair_style lj/cut 2.5 -pair_coeff 1 1 1.0 1.0 2.5 - -neighbor 0.3 bin -neigh_modify delay 0 every 1 check yes - -mdi engine -WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) - generated 0 of 0 mixed pair_coeff terms from geometric mixing rule -Neighbor list info ... - update every 1 steps, delay 0 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 2.8 - ghost atom cutoff = 2.8 - binsize = 1.4, bins = 6 6 6 - 1 neighbor lists, perpetual/occasional/extra = 1 0 0 - (1) pair lj/cut, perpetual - attributes: half, newton on - pair build: half/bin/atomonly/newton - stencil: half/bin/3d - bin: standard -Per MPI rank memory allocation (min/avg/max) = 3.144 | 3.144 | 3.144 Mbytes -Step Temp E_pair E_mol TotEng Press - 0 0 -6.7733681 0 -6.7733681 -6.2353173 - 1 0 -6.7699814 0 -6.7699814 -6.2120481 - 2 0 -6.7596844 0 -6.7596844 -6.1418368 - 3 0 -6.7420029 0 -6.7420029 -6.0231905 - 4 0 -6.7161132 0 -6.7161132 -5.8534999 - 5 0 -6.6808361 0 -6.6808361 -5.6291449 -Total wall time: 0:00:01 diff --git a/examples/mdi/log.7Apr22.mdi.aimdpy.qm.tcp.g++.3 b/examples/mdi/log.7Apr22.mdi.aimdpy.qm.tcp.g++.3 deleted file mode 100644 index cd5d443e65..0000000000 --- a/examples/mdi/log.7Apr22.mdi.aimdpy.qm.tcp.g++.3 +++ /dev/null @@ -1,55 +0,0 @@ -LAMMPS (17 Feb 2022) -# 3d Lennard-Jones melt - LAMMPS as surrogate QM engine for aimd_driver.py - -variable x index 5 -variable y index 5 -variable z index 5 - -units lj -atom_style atomic - -lattice fcc 0.8442 -Lattice spacing in x,y,z = 1.6795962 1.6795962 1.6795962 -region box block 0 $x 0 $y 0 $z -region box block 0 5 0 $y 0 $z -region box block 0 5 0 5 0 $z -region box block 0 5 0 5 0 5 -create_box 1 box -Created orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) - 1 by 1 by 3 MPI processor grid -create_atoms 1 box -Created 500 atoms - using lattice units in orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) - create_atoms CPU = 0.001 seconds -mass 1 1.0 - -pair_style lj/cut 2.5 -pair_coeff 1 1 1.0 1.0 2.5 - -neighbor 0.3 bin -neigh_modify delay 0 every 1 check yes - -mdi engine -WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) - generated 0 of 0 mixed pair_coeff terms from geometric mixing rule -Neighbor list info ... - update every 1 steps, delay 0 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 2.8 - ghost atom cutoff = 2.8 - binsize = 1.4, bins = 6 6 6 - 1 neighbor lists, perpetual/occasional/extra = 1 0 0 - (1) pair lj/cut, perpetual - attributes: half, newton on - pair build: half/bin/atomonly/newton - stencil: half/bin/3d - bin: standard -Per MPI rank memory allocation (min/avg/max) = 3.124 | 3.13 | 3.133 Mbytes -Step Temp E_pair E_mol TotEng Press - 0 0 -6.7733681 0 -6.7733681 -6.2353173 - 1 0 -6.7699814 0 -6.7699814 -6.2120481 - 2 0 -6.7596844 0 -6.7596844 -6.1418368 - 3 0 -6.7420029 0 -6.7420029 -6.0231905 - 4 0 -6.7161132 0 -6.7161132 -5.8534999 - 5 0 -6.6808361 0 -6.6808361 -5.6291449 -Total wall time: 0:00:01 diff --git a/examples/mdi/log.7Apr22.mdi.sequence.driver.mpi.g++.1 b/examples/mdi/log.7Apr22.mdi.sequence.driver.mpi.g++.1 deleted file mode 100644 index 86d23d382b..0000000000 --- a/examples/mdi/log.7Apr22.mdi.sequence.driver.mpi.g++.1 +++ /dev/null @@ -1,3 +0,0 @@ -Calc 1: eng -4.5209 pressure 0.98188 aveForce 4.4409e-16 -1.1102e-16 6.6613e-16 -Calc 2: eng -4.5432 pressure -0.53137 aveForce 7.0083e-16 1.1796e-16 5.4384e-16 -Calc 3: eng -4.501 pressure 2.0049 aveForce 0 2.0817e-16 -4.3021e-16 diff --git a/examples/mdi/log.7Apr22.mdi.sequence.driver.mpi.g++.2 b/examples/mdi/log.7Apr22.mdi.sequence.driver.mpi.g++.2 deleted file mode 100644 index 17e040d0d7..0000000000 --- a/examples/mdi/log.7Apr22.mdi.sequence.driver.mpi.g++.2 +++ /dev/null @@ -1,3 +0,0 @@ -Calc 1: eng -4.5209 pressure 0.98188 aveForce -2.2204e-16 0 2.2204e-16 -Calc 2: eng -4.5432 pressure -0.53137 aveForce -2.498e-16 -1.8735e-16 -3.4001e-16 -Calc 3: eng -4.501 pressure 2.0049 aveForce -7.9103e-16 3.4694e-16 4.0246e-16 diff --git a/examples/mdi/log.7Apr22.mdi.sequence.driver.plugin.g++.1 b/examples/mdi/log.7Apr22.mdi.sequence.driver.plugin.g++.1 deleted file mode 100644 index 86d23d382b..0000000000 --- a/examples/mdi/log.7Apr22.mdi.sequence.driver.plugin.g++.1 +++ /dev/null @@ -1,3 +0,0 @@ -Calc 1: eng -4.5209 pressure 0.98188 aveForce 4.4409e-16 -1.1102e-16 6.6613e-16 -Calc 2: eng -4.5432 pressure -0.53137 aveForce 7.0083e-16 1.1796e-16 5.4384e-16 -Calc 3: eng -4.501 pressure 2.0049 aveForce 0 2.0817e-16 -4.3021e-16 diff --git a/examples/mdi/log.7Apr22.mdi.sequence.driver.plugin.g++.3 b/examples/mdi/log.7Apr22.mdi.sequence.driver.plugin.g++.3 deleted file mode 100644 index e634b156b8..0000000000 --- a/examples/mdi/log.7Apr22.mdi.sequence.driver.plugin.g++.3 +++ /dev/null @@ -1,3 +0,0 @@ -Calc 1: eng -4.5209 pressure 0.98188 aveForce -1.1102e-16 8.3267e-16 1.9429e-16 -Calc 2: eng -4.5432 pressure -0.53137 aveForce 9.0206e-17 4.996e-16 1.5959e-16 -Calc 3: eng -4.501 pressure 2.0049 aveForce -1.4849e-15 -8.1879e-16 -1.7347e-16 diff --git a/examples/mdi/log.7Apr22.mdi.sequence.driver.tcp.g++.1 b/examples/mdi/log.7Apr22.mdi.sequence.driver.tcp.g++.1 deleted file mode 100644 index 86d23d382b..0000000000 --- a/examples/mdi/log.7Apr22.mdi.sequence.driver.tcp.g++.1 +++ /dev/null @@ -1,3 +0,0 @@ -Calc 1: eng -4.5209 pressure 0.98188 aveForce 4.4409e-16 -1.1102e-16 6.6613e-16 -Calc 2: eng -4.5432 pressure -0.53137 aveForce 7.0083e-16 1.1796e-16 5.4384e-16 -Calc 3: eng -4.501 pressure 2.0049 aveForce 0 2.0817e-16 -4.3021e-16 diff --git a/examples/mdi/log.7Apr22.mdi.sequence.driver.tcp.g++.2 b/examples/mdi/log.7Apr22.mdi.sequence.driver.tcp.g++.2 deleted file mode 100644 index 17e040d0d7..0000000000 --- a/examples/mdi/log.7Apr22.mdi.sequence.driver.tcp.g++.2 +++ /dev/null @@ -1,3 +0,0 @@ -Calc 1: eng -4.5209 pressure 0.98188 aveForce -2.2204e-16 0 2.2204e-16 -Calc 2: eng -4.5432 pressure -0.53137 aveForce -2.498e-16 -1.8735e-16 -3.4001e-16 -Calc 3: eng -4.501 pressure 2.0049 aveForce -7.9103e-16 3.4694e-16 4.0246e-16 diff --git a/examples/mdi/log.7Apr22.mdi.sequence.engine.mpi.g++.1 b/examples/mdi/log.7Apr22.mdi.sequence.engine.mpi.g++.1 deleted file mode 100644 index 929cdce5cf..0000000000 --- a/examples/mdi/log.7Apr22.mdi.sequence.engine.mpi.g++.1 +++ /dev/null @@ -1,89 +0,0 @@ -LAMMPS (17 Feb 2022) -# MDI engine script to process a series of evaulate, run, minimize commands - -units lj -atom_style atomic - -lattice fcc 0.8442 -Lattice spacing in x,y,z = 1.6795962 1.6795962 1.6795962 -region box block 0 1 0 1 0 1 -create_box 1 box -Created orthogonal box = (0 0 0) to (1.6795962 1.6795962 1.6795962) - 1 by 1 by 1 MPI processor grid -mass 1 1.0 - -pair_style lj/cut 2.5 -pair_coeff 1 1 1.0 1.0 2.5 - -neighbor 0.3 bin -neigh_modify delay 0 every 1 check yes - -fix 1 all nve - -thermo 10 - -mdi engine -delete_atoms group all -Deleted 0 atoms, new total = 0 - 1 by 1 by 1 MPI processor grid - generated 0 of 0 mixed pair_coeff terms from geometric mixing rule -Neighbor list info ... - update every 1 steps, delay 0 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 2.8 - ghost atom cutoff = 2.8 - binsize = 1.4, bins = 4 4 4 - 1 neighbor lists, perpetual/occasional/extra = 1 0 0 - (1) pair lj/cut, perpetual - attributes: half, newton on - pair build: half/bin/atomonly/newton - stencil: half/bin/3d - bin: standard -Per MPI rank memory allocation (min/avg/max) = 3.077 | 3.077 | 3.077 Mbytes -Step Temp E_pair E_mol TotEng Press - 0 1 -3.9713146 0 -2.4947521 3.1253597 - 10 1.2380002 -4.3210346 0 -2.4930499 2.0015258 - 20 1.173596 -4.2234559 0 -2.4905682 2.3587731 - 30 1.2989994 -4.4124445 0 -2.4943907 1.903698 - 40 1.4510255 -4.6467459 0 -2.504216 1.2196259 - 50 1.4631454 -4.6641774 0 -2.5037518 1.2838406 - 60 1.2694188 -4.3794267 0 -2.5050505 2.4497113 - 70 1.3363814 -4.4759884 0 -2.5027378 2.2441463 - 80 1.402534 -4.5752515 0 -2.5043224 1.9011715 - 90 1.3870321 -4.5512479 0 -2.5032084 2.0040237 - 100 1.3635651 -4.5209384 0 -2.5075493 1.9773816 -delete_atoms group all -Deleted 64 atoms, new total = 0 - 1 by 1 by 1 MPI processor grid - generated 0 of 0 mixed pair_coeff terms from geometric mixing rule -Per MPI rank memory allocation (min/avg/max) = 3.077 | 3.077 | 3.077 Mbytes -Step Temp E_pair E_mol TotEng Press - 0 1 -4.1934138 0 -2.7168513 0.72358299 - 10 1.0170498 -4.2225288 0 -2.7207912 0.7556766 - 20 0.92567967 -4.0920979 0 -2.725274 1.2463143 - 30 1.0851758 -4.3346599 0 -2.73233 0.53176652 - 40 1.2163699 -4.5351986 0 -2.7391524 -0.077915153 - 50 1.2305739 -4.5558134 0 -2.7387942 -0.10711153 - 60 1.1172288 -4.3979372 0 -2.7482791 0.52752067 - 70 1.2228415 -4.5540741 0 -2.7484722 0.11937533 - 80 1.1776333 -4.4870195 0 -2.7481704 0.33904864 - 90 1.219283 -4.5483185 0 -2.747971 0.17898549 - 100 1.2138939 -4.5432229 0 -2.7508327 0.3076354 -delete_atoms group all -Deleted 64 atoms, new total = 0 - 1 by 1 by 1 MPI processor grid - generated 0 of 0 mixed pair_coeff terms from geometric mixing rule -Per MPI rank memory allocation (min/avg/max) = 3.077 | 3.077 | 3.077 Mbytes -Step Temp E_pair E_mol TotEng Press - 0 1 -3.8524214 0 -2.3758589 4.6814052 - 10 1.3356745 -4.3481612 0 -2.3759544 3.061856 - 20 1.1791601 -4.117932 0 -2.3768284 3.8565 - 30 1.3435556 -4.3613609 0 -2.3775171 3.0728735 - 40 1.5628445 -4.6886004 0 -2.3809628 2.0989245 - 50 1.4735556 -4.5569123 0 -2.3811152 2.6364099 - 60 1.609387 -4.7581056 0 -2.3817452 1.8988642 - 70 1.5014902 -4.5938759 0 -2.3768318 2.458161 - 80 1.3763383 -4.4089865 0 -2.3767369 3.0379808 - 90 1.498202 -4.5909613 0 -2.3787724 2.5543714 - 100 1.43934 -4.5009545 0 -2.375679 3.0923444 -Total wall time: 0:00:00 diff --git a/examples/mdi/log.7Apr22.mdi.sequence.engine.mpi.g++.4 b/examples/mdi/log.7Apr22.mdi.sequence.engine.mpi.g++.4 deleted file mode 100644 index ada69c6ca7..0000000000 --- a/examples/mdi/log.7Apr22.mdi.sequence.engine.mpi.g++.4 +++ /dev/null @@ -1,89 +0,0 @@ -LAMMPS (17 Feb 2022) -# MDI engine script to process a series of evaulate, run, minimize commands - -units lj -atom_style atomic - -lattice fcc 0.8442 -Lattice spacing in x,y,z = 1.6795962 1.6795962 1.6795962 -region box block 0 1 0 1 0 1 -create_box 1 box -Created orthogonal box = (0 0 0) to (1.6795962 1.6795962 1.6795962) - 1 by 2 by 2 MPI processor grid -mass 1 1.0 - -pair_style lj/cut 2.5 -pair_coeff 1 1 1.0 1.0 2.5 - -neighbor 0.3 bin -neigh_modify delay 0 every 1 check yes - -fix 1 all nve - -thermo 10 - -mdi engine -delete_atoms group all -Deleted 0 atoms, new total = 0 - 1 by 2 by 2 MPI processor grid - generated 0 of 0 mixed pair_coeff terms from geometric mixing rule -Neighbor list info ... - update every 1 steps, delay 0 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 2.8 - ghost atom cutoff = 2.8 - binsize = 1.4, bins = 4 4 4 - 1 neighbor lists, perpetual/occasional/extra = 1 0 0 - (1) pair lj/cut, perpetual - attributes: half, newton on - pair build: half/bin/atomonly/newton - stencil: half/bin/3d - bin: standard -Per MPI rank memory allocation (min/avg/max) = 3.077 | 3.077 | 3.077 Mbytes -Step Temp E_pair E_mol TotEng Press - 0 1 -3.9713146 0 -2.4947521 3.1253597 - 10 1.2380002 -4.3210346 0 -2.4930499 2.0015258 - 20 1.173596 -4.2234559 0 -2.4905682 2.3587731 - 30 1.2989994 -4.4124445 0 -2.4943907 1.903698 - 40 1.4510255 -4.6467459 0 -2.504216 1.2196259 - 50 1.4631454 -4.6641774 0 -2.5037518 1.2838406 - 60 1.2694188 -4.3794267 0 -2.5050505 2.4497113 - 70 1.3363814 -4.4759884 0 -2.5027378 2.2441463 - 80 1.402534 -4.5752515 0 -2.5043224 1.9011715 - 90 1.3870321 -4.5512479 0 -2.5032084 2.0040237 - 100 1.3635651 -4.5209384 0 -2.5075493 1.9773816 -delete_atoms group all -Deleted 64 atoms, new total = 0 - 1 by 2 by 2 MPI processor grid - generated 0 of 0 mixed pair_coeff terms from geometric mixing rule -Per MPI rank memory allocation (min/avg/max) = 3.077 | 3.077 | 3.077 Mbytes -Step Temp E_pair E_mol TotEng Press - 0 1 -4.1934138 0 -2.7168513 0.72358299 - 10 1.0170498 -4.2225288 0 -2.7207912 0.7556766 - 20 0.92567967 -4.0920979 0 -2.725274 1.2463143 - 30 1.0851758 -4.3346599 0 -2.73233 0.53176652 - 40 1.2163699 -4.5351986 0 -2.7391524 -0.077915153 - 50 1.2305739 -4.5558134 0 -2.7387942 -0.10711153 - 60 1.1172288 -4.3979372 0 -2.7482791 0.52752067 - 70 1.2228415 -4.5540741 0 -2.7484722 0.11937533 - 80 1.1776333 -4.4870195 0 -2.7481704 0.33904864 - 90 1.219283 -4.5483185 0 -2.747971 0.17898549 - 100 1.2138939 -4.5432229 0 -2.7508327 0.3076354 -delete_atoms group all -Deleted 64 atoms, new total = 0 - 1 by 2 by 2 MPI processor grid - generated 0 of 0 mixed pair_coeff terms from geometric mixing rule -Per MPI rank memory allocation (min/avg/max) = 3.077 | 3.077 | 3.077 Mbytes -Step Temp E_pair E_mol TotEng Press - 0 1 -3.8524214 0 -2.3758589 4.6814052 - 10 1.3356745 -4.3481612 0 -2.3759544 3.061856 - 20 1.1791601 -4.117932 0 -2.3768284 3.8565 - 30 1.3435556 -4.3613609 0 -2.3775171 3.0728735 - 40 1.5628445 -4.6886004 0 -2.3809628 2.0989245 - 50 1.4735556 -4.5569123 0 -2.3811152 2.6364099 - 60 1.609387 -4.7581056 0 -2.3817452 1.8988642 - 70 1.5014902 -4.5938759 0 -2.3768318 2.458161 - 80 1.3763383 -4.4089865 0 -2.3767369 3.0379808 - 90 1.498202 -4.5909613 0 -2.3787724 2.5543714 - 100 1.43934 -4.5009545 0 -2.375679 3.0923444 -Total wall time: 0:00:00 diff --git a/examples/mdi/log.7Apr22.mdi.sequence.engine.plugin.g++.1 b/examples/mdi/log.7Apr22.mdi.sequence.engine.plugin.g++.1 deleted file mode 100644 index 929cdce5cf..0000000000 --- a/examples/mdi/log.7Apr22.mdi.sequence.engine.plugin.g++.1 +++ /dev/null @@ -1,89 +0,0 @@ -LAMMPS (17 Feb 2022) -# MDI engine script to process a series of evaulate, run, minimize commands - -units lj -atom_style atomic - -lattice fcc 0.8442 -Lattice spacing in x,y,z = 1.6795962 1.6795962 1.6795962 -region box block 0 1 0 1 0 1 -create_box 1 box -Created orthogonal box = (0 0 0) to (1.6795962 1.6795962 1.6795962) - 1 by 1 by 1 MPI processor grid -mass 1 1.0 - -pair_style lj/cut 2.5 -pair_coeff 1 1 1.0 1.0 2.5 - -neighbor 0.3 bin -neigh_modify delay 0 every 1 check yes - -fix 1 all nve - -thermo 10 - -mdi engine -delete_atoms group all -Deleted 0 atoms, new total = 0 - 1 by 1 by 1 MPI processor grid - generated 0 of 0 mixed pair_coeff terms from geometric mixing rule -Neighbor list info ... - update every 1 steps, delay 0 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 2.8 - ghost atom cutoff = 2.8 - binsize = 1.4, bins = 4 4 4 - 1 neighbor lists, perpetual/occasional/extra = 1 0 0 - (1) pair lj/cut, perpetual - attributes: half, newton on - pair build: half/bin/atomonly/newton - stencil: half/bin/3d - bin: standard -Per MPI rank memory allocation (min/avg/max) = 3.077 | 3.077 | 3.077 Mbytes -Step Temp E_pair E_mol TotEng Press - 0 1 -3.9713146 0 -2.4947521 3.1253597 - 10 1.2380002 -4.3210346 0 -2.4930499 2.0015258 - 20 1.173596 -4.2234559 0 -2.4905682 2.3587731 - 30 1.2989994 -4.4124445 0 -2.4943907 1.903698 - 40 1.4510255 -4.6467459 0 -2.504216 1.2196259 - 50 1.4631454 -4.6641774 0 -2.5037518 1.2838406 - 60 1.2694188 -4.3794267 0 -2.5050505 2.4497113 - 70 1.3363814 -4.4759884 0 -2.5027378 2.2441463 - 80 1.402534 -4.5752515 0 -2.5043224 1.9011715 - 90 1.3870321 -4.5512479 0 -2.5032084 2.0040237 - 100 1.3635651 -4.5209384 0 -2.5075493 1.9773816 -delete_atoms group all -Deleted 64 atoms, new total = 0 - 1 by 1 by 1 MPI processor grid - generated 0 of 0 mixed pair_coeff terms from geometric mixing rule -Per MPI rank memory allocation (min/avg/max) = 3.077 | 3.077 | 3.077 Mbytes -Step Temp E_pair E_mol TotEng Press - 0 1 -4.1934138 0 -2.7168513 0.72358299 - 10 1.0170498 -4.2225288 0 -2.7207912 0.7556766 - 20 0.92567967 -4.0920979 0 -2.725274 1.2463143 - 30 1.0851758 -4.3346599 0 -2.73233 0.53176652 - 40 1.2163699 -4.5351986 0 -2.7391524 -0.077915153 - 50 1.2305739 -4.5558134 0 -2.7387942 -0.10711153 - 60 1.1172288 -4.3979372 0 -2.7482791 0.52752067 - 70 1.2228415 -4.5540741 0 -2.7484722 0.11937533 - 80 1.1776333 -4.4870195 0 -2.7481704 0.33904864 - 90 1.219283 -4.5483185 0 -2.747971 0.17898549 - 100 1.2138939 -4.5432229 0 -2.7508327 0.3076354 -delete_atoms group all -Deleted 64 atoms, new total = 0 - 1 by 1 by 1 MPI processor grid - generated 0 of 0 mixed pair_coeff terms from geometric mixing rule -Per MPI rank memory allocation (min/avg/max) = 3.077 | 3.077 | 3.077 Mbytes -Step Temp E_pair E_mol TotEng Press - 0 1 -3.8524214 0 -2.3758589 4.6814052 - 10 1.3356745 -4.3481612 0 -2.3759544 3.061856 - 20 1.1791601 -4.117932 0 -2.3768284 3.8565 - 30 1.3435556 -4.3613609 0 -2.3775171 3.0728735 - 40 1.5628445 -4.6886004 0 -2.3809628 2.0989245 - 50 1.4735556 -4.5569123 0 -2.3811152 2.6364099 - 60 1.609387 -4.7581056 0 -2.3817452 1.8988642 - 70 1.5014902 -4.5938759 0 -2.3768318 2.458161 - 80 1.3763383 -4.4089865 0 -2.3767369 3.0379808 - 90 1.498202 -4.5909613 0 -2.3787724 2.5543714 - 100 1.43934 -4.5009545 0 -2.375679 3.0923444 -Total wall time: 0:00:00 diff --git a/examples/mdi/log.7Apr22.mdi.sequence.engine.plugin.g++.3 b/examples/mdi/log.7Apr22.mdi.sequence.engine.plugin.g++.3 deleted file mode 100644 index df8d258715..0000000000 --- a/examples/mdi/log.7Apr22.mdi.sequence.engine.plugin.g++.3 +++ /dev/null @@ -1,89 +0,0 @@ -LAMMPS (17 Feb 2022) -# MDI engine script to process a series of evaulate, run, minimize commands - -units lj -atom_style atomic - -lattice fcc 0.8442 -Lattice spacing in x,y,z = 1.6795962 1.6795962 1.6795962 -region box block 0 1 0 1 0 1 -create_box 1 box -Created orthogonal box = (0 0 0) to (1.6795962 1.6795962 1.6795962) - 1 by 1 by 3 MPI processor grid -mass 1 1.0 - -pair_style lj/cut 2.5 -pair_coeff 1 1 1.0 1.0 2.5 - -neighbor 0.3 bin -neigh_modify delay 0 every 1 check yes - -fix 1 all nve - -thermo 10 - -mdi engine -delete_atoms group all -Deleted 0 atoms, new total = 0 - 1 by 1 by 3 MPI processor grid - generated 0 of 0 mixed pair_coeff terms from geometric mixing rule -Neighbor list info ... - update every 1 steps, delay 0 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 2.8 - ghost atom cutoff = 2.8 - binsize = 1.4, bins = 4 4 4 - 1 neighbor lists, perpetual/occasional/extra = 1 0 0 - (1) pair lj/cut, perpetual - attributes: half, newton on - pair build: half/bin/atomonly/newton - stencil: half/bin/3d - bin: standard -Per MPI rank memory allocation (min/avg/max) = 3.07 | 3.07 | 3.071 Mbytes -Step Temp E_pair E_mol TotEng Press - 0 1 -3.9713146 0 -2.4947521 3.1253597 - 10 1.2380002 -4.3210346 0 -2.4930499 2.0015258 - 20 1.173596 -4.2234559 0 -2.4905682 2.3587731 - 30 1.2989994 -4.4124445 0 -2.4943907 1.903698 - 40 1.4510255 -4.6467459 0 -2.504216 1.2196259 - 50 1.4631454 -4.6641774 0 -2.5037518 1.2838406 - 60 1.2694188 -4.3794267 0 -2.5050505 2.4497113 - 70 1.3363814 -4.4759884 0 -2.5027378 2.2441463 - 80 1.402534 -4.5752515 0 -2.5043224 1.9011715 - 90 1.3870321 -4.5512479 0 -2.5032084 2.0040237 - 100 1.3635651 -4.5209384 0 -2.5075493 1.9773816 -delete_atoms group all -Deleted 64 atoms, new total = 0 - 1 by 1 by 3 MPI processor grid - generated 0 of 0 mixed pair_coeff terms from geometric mixing rule -Per MPI rank memory allocation (min/avg/max) = 3.07 | 3.07 | 3.071 Mbytes -Step Temp E_pair E_mol TotEng Press - 0 1 -4.1934138 0 -2.7168513 0.72358299 - 10 1.0170498 -4.2225288 0 -2.7207912 0.7556766 - 20 0.92567967 -4.0920979 0 -2.725274 1.2463143 - 30 1.0851758 -4.3346599 0 -2.73233 0.53176652 - 40 1.2163699 -4.5351986 0 -2.7391524 -0.077915153 - 50 1.2305739 -4.5558134 0 -2.7387942 -0.10711153 - 60 1.1172288 -4.3979372 0 -2.7482791 0.52752067 - 70 1.2228415 -4.5540741 0 -2.7484722 0.11937533 - 80 1.1776333 -4.4870195 0 -2.7481704 0.33904864 - 90 1.219283 -4.5483185 0 -2.747971 0.17898549 - 100 1.2138939 -4.5432229 0 -2.7508327 0.3076354 -delete_atoms group all -Deleted 64 atoms, new total = 0 - 3 by 1 by 1 MPI processor grid - generated 0 of 0 mixed pair_coeff terms from geometric mixing rule -Per MPI rank memory allocation (min/avg/max) = 3.07 | 3.07 | 3.071 Mbytes -Step Temp E_pair E_mol TotEng Press - 0 1 -3.8524214 0 -2.3758589 4.6814052 - 10 1.3356745 -4.3481612 0 -2.3759544 3.061856 - 20 1.1791601 -4.117932 0 -2.3768284 3.8565 - 30 1.3435556 -4.3613609 0 -2.3775171 3.0728735 - 40 1.5628445 -4.6886004 0 -2.3809628 2.0989245 - 50 1.4735556 -4.5569123 0 -2.3811152 2.6364099 - 60 1.609387 -4.7581056 0 -2.3817452 1.8988642 - 70 1.5014902 -4.5938759 0 -2.3768318 2.458161 - 80 1.3763383 -4.4089865 0 -2.3767369 3.0379808 - 90 1.498202 -4.5909613 0 -2.3787724 2.5543714 - 100 1.43934 -4.5009545 0 -2.375679 3.0923444 -Total wall time: 0:00:00 diff --git a/examples/mdi/log.7Apr22.mdi.sequence.engine.tcp.g++.1 b/examples/mdi/log.7Apr22.mdi.sequence.engine.tcp.g++.1 deleted file mode 100644 index 929cdce5cf..0000000000 --- a/examples/mdi/log.7Apr22.mdi.sequence.engine.tcp.g++.1 +++ /dev/null @@ -1,89 +0,0 @@ -LAMMPS (17 Feb 2022) -# MDI engine script to process a series of evaulate, run, minimize commands - -units lj -atom_style atomic - -lattice fcc 0.8442 -Lattice spacing in x,y,z = 1.6795962 1.6795962 1.6795962 -region box block 0 1 0 1 0 1 -create_box 1 box -Created orthogonal box = (0 0 0) to (1.6795962 1.6795962 1.6795962) - 1 by 1 by 1 MPI processor grid -mass 1 1.0 - -pair_style lj/cut 2.5 -pair_coeff 1 1 1.0 1.0 2.5 - -neighbor 0.3 bin -neigh_modify delay 0 every 1 check yes - -fix 1 all nve - -thermo 10 - -mdi engine -delete_atoms group all -Deleted 0 atoms, new total = 0 - 1 by 1 by 1 MPI processor grid - generated 0 of 0 mixed pair_coeff terms from geometric mixing rule -Neighbor list info ... - update every 1 steps, delay 0 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 2.8 - ghost atom cutoff = 2.8 - binsize = 1.4, bins = 4 4 4 - 1 neighbor lists, perpetual/occasional/extra = 1 0 0 - (1) pair lj/cut, perpetual - attributes: half, newton on - pair build: half/bin/atomonly/newton - stencil: half/bin/3d - bin: standard -Per MPI rank memory allocation (min/avg/max) = 3.077 | 3.077 | 3.077 Mbytes -Step Temp E_pair E_mol TotEng Press - 0 1 -3.9713146 0 -2.4947521 3.1253597 - 10 1.2380002 -4.3210346 0 -2.4930499 2.0015258 - 20 1.173596 -4.2234559 0 -2.4905682 2.3587731 - 30 1.2989994 -4.4124445 0 -2.4943907 1.903698 - 40 1.4510255 -4.6467459 0 -2.504216 1.2196259 - 50 1.4631454 -4.6641774 0 -2.5037518 1.2838406 - 60 1.2694188 -4.3794267 0 -2.5050505 2.4497113 - 70 1.3363814 -4.4759884 0 -2.5027378 2.2441463 - 80 1.402534 -4.5752515 0 -2.5043224 1.9011715 - 90 1.3870321 -4.5512479 0 -2.5032084 2.0040237 - 100 1.3635651 -4.5209384 0 -2.5075493 1.9773816 -delete_atoms group all -Deleted 64 atoms, new total = 0 - 1 by 1 by 1 MPI processor grid - generated 0 of 0 mixed pair_coeff terms from geometric mixing rule -Per MPI rank memory allocation (min/avg/max) = 3.077 | 3.077 | 3.077 Mbytes -Step Temp E_pair E_mol TotEng Press - 0 1 -4.1934138 0 -2.7168513 0.72358299 - 10 1.0170498 -4.2225288 0 -2.7207912 0.7556766 - 20 0.92567967 -4.0920979 0 -2.725274 1.2463143 - 30 1.0851758 -4.3346599 0 -2.73233 0.53176652 - 40 1.2163699 -4.5351986 0 -2.7391524 -0.077915153 - 50 1.2305739 -4.5558134 0 -2.7387942 -0.10711153 - 60 1.1172288 -4.3979372 0 -2.7482791 0.52752067 - 70 1.2228415 -4.5540741 0 -2.7484722 0.11937533 - 80 1.1776333 -4.4870195 0 -2.7481704 0.33904864 - 90 1.219283 -4.5483185 0 -2.747971 0.17898549 - 100 1.2138939 -4.5432229 0 -2.7508327 0.3076354 -delete_atoms group all -Deleted 64 atoms, new total = 0 - 1 by 1 by 1 MPI processor grid - generated 0 of 0 mixed pair_coeff terms from geometric mixing rule -Per MPI rank memory allocation (min/avg/max) = 3.077 | 3.077 | 3.077 Mbytes -Step Temp E_pair E_mol TotEng Press - 0 1 -3.8524214 0 -2.3758589 4.6814052 - 10 1.3356745 -4.3481612 0 -2.3759544 3.061856 - 20 1.1791601 -4.117932 0 -2.3768284 3.8565 - 30 1.3435556 -4.3613609 0 -2.3775171 3.0728735 - 40 1.5628445 -4.6886004 0 -2.3809628 2.0989245 - 50 1.4735556 -4.5569123 0 -2.3811152 2.6364099 - 60 1.609387 -4.7581056 0 -2.3817452 1.8988642 - 70 1.5014902 -4.5938759 0 -2.3768318 2.458161 - 80 1.3763383 -4.4089865 0 -2.3767369 3.0379808 - 90 1.498202 -4.5909613 0 -2.3787724 2.5543714 - 100 1.43934 -4.5009545 0 -2.375679 3.0923444 -Total wall time: 0:00:00 diff --git a/examples/mdi/log.7Apr22.mdi.sequence.engine.tcp.g++.4 b/examples/mdi/log.7Apr22.mdi.sequence.engine.tcp.g++.4 deleted file mode 100644 index ada69c6ca7..0000000000 --- a/examples/mdi/log.7Apr22.mdi.sequence.engine.tcp.g++.4 +++ /dev/null @@ -1,89 +0,0 @@ -LAMMPS (17 Feb 2022) -# MDI engine script to process a series of evaulate, run, minimize commands - -units lj -atom_style atomic - -lattice fcc 0.8442 -Lattice spacing in x,y,z = 1.6795962 1.6795962 1.6795962 -region box block 0 1 0 1 0 1 -create_box 1 box -Created orthogonal box = (0 0 0) to (1.6795962 1.6795962 1.6795962) - 1 by 2 by 2 MPI processor grid -mass 1 1.0 - -pair_style lj/cut 2.5 -pair_coeff 1 1 1.0 1.0 2.5 - -neighbor 0.3 bin -neigh_modify delay 0 every 1 check yes - -fix 1 all nve - -thermo 10 - -mdi engine -delete_atoms group all -Deleted 0 atoms, new total = 0 - 1 by 2 by 2 MPI processor grid - generated 0 of 0 mixed pair_coeff terms from geometric mixing rule -Neighbor list info ... - update every 1 steps, delay 0 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 2.8 - ghost atom cutoff = 2.8 - binsize = 1.4, bins = 4 4 4 - 1 neighbor lists, perpetual/occasional/extra = 1 0 0 - (1) pair lj/cut, perpetual - attributes: half, newton on - pair build: half/bin/atomonly/newton - stencil: half/bin/3d - bin: standard -Per MPI rank memory allocation (min/avg/max) = 3.077 | 3.077 | 3.077 Mbytes -Step Temp E_pair E_mol TotEng Press - 0 1 -3.9713146 0 -2.4947521 3.1253597 - 10 1.2380002 -4.3210346 0 -2.4930499 2.0015258 - 20 1.173596 -4.2234559 0 -2.4905682 2.3587731 - 30 1.2989994 -4.4124445 0 -2.4943907 1.903698 - 40 1.4510255 -4.6467459 0 -2.504216 1.2196259 - 50 1.4631454 -4.6641774 0 -2.5037518 1.2838406 - 60 1.2694188 -4.3794267 0 -2.5050505 2.4497113 - 70 1.3363814 -4.4759884 0 -2.5027378 2.2441463 - 80 1.402534 -4.5752515 0 -2.5043224 1.9011715 - 90 1.3870321 -4.5512479 0 -2.5032084 2.0040237 - 100 1.3635651 -4.5209384 0 -2.5075493 1.9773816 -delete_atoms group all -Deleted 64 atoms, new total = 0 - 1 by 2 by 2 MPI processor grid - generated 0 of 0 mixed pair_coeff terms from geometric mixing rule -Per MPI rank memory allocation (min/avg/max) = 3.077 | 3.077 | 3.077 Mbytes -Step Temp E_pair E_mol TotEng Press - 0 1 -4.1934138 0 -2.7168513 0.72358299 - 10 1.0170498 -4.2225288 0 -2.7207912 0.7556766 - 20 0.92567967 -4.0920979 0 -2.725274 1.2463143 - 30 1.0851758 -4.3346599 0 -2.73233 0.53176652 - 40 1.2163699 -4.5351986 0 -2.7391524 -0.077915153 - 50 1.2305739 -4.5558134 0 -2.7387942 -0.10711153 - 60 1.1172288 -4.3979372 0 -2.7482791 0.52752067 - 70 1.2228415 -4.5540741 0 -2.7484722 0.11937533 - 80 1.1776333 -4.4870195 0 -2.7481704 0.33904864 - 90 1.219283 -4.5483185 0 -2.747971 0.17898549 - 100 1.2138939 -4.5432229 0 -2.7508327 0.3076354 -delete_atoms group all -Deleted 64 atoms, new total = 0 - 1 by 2 by 2 MPI processor grid - generated 0 of 0 mixed pair_coeff terms from geometric mixing rule -Per MPI rank memory allocation (min/avg/max) = 3.077 | 3.077 | 3.077 Mbytes -Step Temp E_pair E_mol TotEng Press - 0 1 -3.8524214 0 -2.3758589 4.6814052 - 10 1.3356745 -4.3481612 0 -2.3759544 3.061856 - 20 1.1791601 -4.117932 0 -2.3768284 3.8565 - 30 1.3435556 -4.3613609 0 -2.3775171 3.0728735 - 40 1.5628445 -4.6886004 0 -2.3809628 2.0989245 - 50 1.4735556 -4.5569123 0 -2.3811152 2.6364099 - 60 1.609387 -4.7581056 0 -2.3817452 1.8988642 - 70 1.5014902 -4.5938759 0 -2.3768318 2.458161 - 80 1.3763383 -4.4089865 0 -2.3767369 3.0379808 - 90 1.498202 -4.5909613 0 -2.3787724 2.5543714 - 100 1.43934 -4.5009545 0 -2.375679 3.0923444 -Total wall time: 0:00:00 diff --git a/src/MDI/fix_mdi_qm.cpp b/src/MDI/fix_mdi_qm.cpp index 9a6e415a8c..99f23f7e59 100644 --- a/src/MDI/fix_mdi_qm.cpp +++ b/src/MDI/fix_mdi_qm.cpp @@ -48,7 +48,7 @@ FixMDIQM::FixMDIQM(LAMMPS *lmp, int narg, char **arg) : Fix(lmp, narg, arg) virialflag = 0; addflag = 1; every = 1; - extflag = 0; + connectflag = 1; int iarg = 3; while (iarg < narg) { @@ -69,10 +69,10 @@ FixMDIQM::FixMDIQM(LAMMPS *lmp, int narg, char **arg) : Fix(lmp, narg, arg) every = utils::inumeric(FLERR,arg[iarg+1],false,lmp); if (every <= 0) error->all(FLERR,"Illegal fix mdi/qm command"); iarg += 2; - } else if (strcmp(arg[iarg],"external") == 0) { + } else if (strcmp(arg[iarg],"connect") == 0) { if (iarg+2 > narg) error->all(FLERR,"Illegal fix mdi/qm command"); - if (strcmp(arg[iarg+1],"yes") == 0) extflag = 1; - else if (strcmp(arg[iarg+1],"no") == 0) extflag = 0; + if (strcmp(arg[iarg+1],"yes") == 0) connectflag = 1; + else if (strcmp(arg[iarg+1],"no") == 0) connectflag = 0; else error->all(FLERR,"Illegal fix mdi/qm command"); iarg += 2; } else error->all(FLERR,"Illegal fix mdi/qm command"); @@ -100,8 +100,8 @@ FixMDIQM::FixMDIQM(LAMMPS *lmp, int narg, char **arg) : Fix(lmp, narg, arg) thermo_energy = thermo_virial = 1; } - // mdicomm will be one-time initialized in init() - // cannot be done here for a plugin library, b/c mdi plugin command is later + // mdicomm will be initialized in init() + // cannot do here for a plugin library, b/c mdi plugin command comes later mdicomm = MDI_COMM_NULL; @@ -143,10 +143,11 @@ FixMDIQM::FixMDIQM(LAMMPS *lmp, int narg, char **arg) : Fix(lmp, narg, arg) FixMDIQM::~FixMDIQM() { - // send exit command to engine if it is a stand-alone code - // for plugin, this happens in MDIPlugin::plugin_wrapper() + // send exit command to stand-alone engine code + // for connnectflag = 0, this is done via "mdi exit" command + // for plugin, this is done in MDIPlugin::plugin_wrapper() - if (!plugin && !extflag) { + if (mdicomm != MDI_COMM_NULL && connectflag && !plugin) { int ierr = MDI_Send_command("EXIT", mdicomm); if (ierr) error->all(FLERR, "MDI: EXIT command"); } @@ -176,31 +177,47 @@ int FixMDIQM::setmask() void FixMDIQM::init() { - // one-time auto-detect whether engine is stand-alone code or plugin library - // also initializes mdicomm - // set plugin = 0/1 for engine = stand-alone code vs plugin library - - if (!extflag) { + // set local mdicomm one-time only + // also set plugin = 0/1 for engine = stand-alone code vs plugin library if (mdicomm == MDI_COMM_NULL) { - MDI_Get_communicator(&mdicomm, 0); - if (mdicomm == MDI_COMM_NULL) { - plugin = 0; - MDI_Accept_communicator(&mdicomm); - if (mdicomm == MDI_COMM_NULL) - error->all(FLERR, "MDI unable to connect to stand-alone engine"); - } else { - plugin = 1; - int method; - MDI_Get_method(&method, mdicomm); - if (method != MDI_PLUGIN) - error->all(FLERR, "MDI internal error for plugin engine"); - } - } - } else { - plugin = 0; - mdicomm = lmp->mdicomm; + // this fix makes one-time connection to engine + + if (connectflag) { + + // if MDI's mdicomm not set, need to Accept_comm() with stand-alone engine + // othewise are already connected to plugin engine + + MDI_Get_communicator(&mdicomm, 0); + + if (mdicomm == MDI_COMM_NULL) { + plugin = 0; + MDI_Accept_communicator(&mdicomm); + if (mdicomm == MDI_COMM_NULL) + error->all(FLERR, "MDI unable to connect to stand-alone engine"); + + } else { + plugin = 1; + int method; + MDI_Get_method(&method, mdicomm); + if (method != MDI_PLUGIN) + error->all(FLERR, "MDI internal error for plugin engine"); + } + + // connection should have been already made by "mdi connect" command + // only works for stand-alone engines + + } else { + plugin = 0; + + if (lmp->mdicomm == nullptr) + error->all(FLERR,"Fix mdi/qm is not connected to engine via mdi connect"); + + int nbytes = sizeof(MDI_Comm); + char *ptrcomm = (char *) lmp->mdicomm; + memcpy(&mdicomm,ptrcomm,nbytes); + } } // send natoms, atom types, and simulation box to engine diff --git a/src/MDI/fix_mdi_qm.h b/src/MDI/fix_mdi_qm.h index b805f7e3d2..2d6f4b0d23 100644 --- a/src/MDI/fix_mdi_qm.h +++ b/src/MDI/fix_mdi_qm.h @@ -40,7 +40,7 @@ class FixMDIQM : public Fix { private: int nprocs; - int virialflag,addflag,extflag,every; + int every,virialflag,addflag,connectflag; int plugin; int maxlocal; int sumflag; diff --git a/src/MDI/mdi_command.cpp b/src/MDI/mdi_command.cpp index 9fdc1f8a04..96ba839dfc 100644 --- a/src/MDI/mdi_command.cpp +++ b/src/MDI/mdi_command.cpp @@ -16,13 +16,19 @@ #include "error.h" #include "mdi_engine.h" #include "mdi_plugin.h" +#include "memory.h" #include using namespace LAMMPS_NS; /* ---------------------------------------------------------------------- - mdi command: engine or plugin + mdi command: engine or plugin or connect or exit + engine is used when LAMMPS is an MDI engine, to start listening for requests + plugin is used when LAMMPS is an MDI driver to load a plugin library + connect and exit are used when LAMMPS is an MDI driver to + (a) connect = setup comm with a stand-alone MDI engine + (b) exit = terminate comm with a stand-alone MDI engine ---------------------------------------------------------------------- */ void MDICommand::command(int narg, char **arg) @@ -35,22 +41,41 @@ void MDICommand::command(int narg, char **arg) } else if (strcmp(arg[0], "plugin") == 0) { MDIPlugin(lmp, narg - 1, &arg[1]); - } else if (strcmp(arg[0], "start") == 0) { + } else if (strcmp(arg[0], "connect") == 0) { + + if (lmp->mdicomm != nullptr) + error->all(FLERR,"MDI cannot connect to already connected engine"); + MDI_Comm mdicomm; MDI_Get_communicator(&mdicomm, 0); + if (mdicomm == MDI_COMM_NULL) { MDI_Accept_communicator(&mdicomm); if (mdicomm == MDI_COMM_NULL) error->all(FLERR, "MDI unable to connect to stand-alone engine"); - } else error->all(FLERR, "Cannot use mdi start in plugin mode"); - lmp->mdicomm = mdicomm; + } else error->all(FLERR, "Cannot use mdi connect with plugin engine"); - } else if (strcmp(arg[0], "stop") == 0) { + int nbytes = sizeof(MDI_Comm); + char *ptrcomm = (char *) memory->smalloc(nbytes,"mdi:mdicomm"); + memcpy(ptrcomm,&mdicomm,nbytes); + + lmp->mdicomm = (void *) ptrcomm; + + } else if (strcmp(arg[0], "exit") == 0) { + + if (lmp->mdicomm == nullptr) + error->all(FLERR,"MDI cannot send exit to unconnected engine"); + + MDI_Comm mdicomm; + int nbytes = sizeof(MDI_Comm); + char *ptrcomm = (char *) lmp->mdicomm; + memcpy(&mdicomm,ptrcomm,nbytes); - MDI_Comm mdicomm = lmp->mdicomm; int ierr = MDI_Send_command("EXIT", mdicomm); if (ierr) error->all(FLERR, "MDI: EXIT command"); - lmp->mdicomm = MDI_COMM_NULL; + + memory->sfree(ptrcomm); + lmp->mdicomm = nullptr; } else error->all(FLERR, "Illegal mdi command"); } diff --git a/src/lammps.cpp b/src/lammps.cpp index d4c7288451..3ddfafeb5d 100644 --- a/src/lammps.cpp +++ b/src/lammps.cpp @@ -130,7 +130,7 @@ LAMMPS::LAMMPS(int narg, char **arg, MPI_Comm communicator) : num_ver = utils::date2num(version); external_comm = 0; - mdicomm = 0; + mdicomm = nullptr; skiprunflag = 0; diff --git a/src/lammps.h b/src/lammps.h index 04ab9a9673..4cdb873db9 100644 --- a/src/lammps.h +++ b/src/lammps.h @@ -69,7 +69,7 @@ class LAMMPS { // when multiple programs launched by mpirun // set by -mpicolor command line arg - int mdicomm; // for use with MDI code coupling library + void *mdicomm; // for use with MDI code coupling library const char *match_style(const char *style, const char *name); static const char *installed_packages[]; From 9ca91bfe8010ce28167d7cc5e3f350bcb9e4fe8f Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Wed, 15 Jun 2022 18:14:27 -0600 Subject: [PATCH 366/585] Created two simple examples of compute sna/grid and sna/grid/local --- examples/snap/README.grid | 10 ++ examples/snap/in.grid.snap | 94 ++++++++++ examples/snap/in.grid.tri | 143 +++++++--------- examples/snap/log.15Jun22.grid.snap.g++.1 | 167 ++++++++++++++++++ examples/snap/log.15Jun22.grid.snap.g++.4 | 168 ++++++++++++++++++ examples/snap/log.15Jun22.grid.tri.g++.1 | 200 ++++++++++++++++++++++ examples/snap/log.15Jun22.grid.tri.g++.4 | 200 ++++++++++++++++++++++ 7 files changed, 900 insertions(+), 82 deletions(-) create mode 100644 examples/snap/in.grid.snap create mode 100644 examples/snap/log.15Jun22.grid.snap.g++.1 create mode 100644 examples/snap/log.15Jun22.grid.snap.g++.4 create mode 100644 examples/snap/log.15Jun22.grid.tri.g++.1 create mode 100644 examples/snap/log.15Jun22.grid.tri.g++.4 diff --git a/examples/snap/README.grid b/examples/snap/README.grid index 9033c9d445..a552ce38ab 100644 --- a/examples/snap/README.grid +++ b/examples/snap/README.grid @@ -7,3 +7,13 @@ in.grid.test # stress test of grid and grid/local in.grid.tri # grid with triclinic cell grid.py # access data from Python library interface + +For the LAMMPS public repo, the only examples that will be provided are: + + in.grid.snap # simple test of grid and grid/local + in.grid.tri # same for a triclinic box + log.15Jun22.grid.snap.g++.1 + log.15Jun22.grid.snap.g++.4 + log.15Jun22.grid.tri.g++.1 + log.15Jun22.grid.tri.g++.4 + diff --git a/examples/snap/in.grid.snap b/examples/snap/in.grid.snap new file mode 100644 index 0000000000..08c95a004f --- /dev/null +++ b/examples/snap/in.grid.snap @@ -0,0 +1,94 @@ +# Demonstrate calculation of SNAP bispectrum descriptors on a grid + +# CORRECTNESS: The two atom positions coincide with two of +# the gridpoints, so c_b[2][1-5] should match c_mygrid[8][4-8]. +# The same is true for compute grid/local c_mygridlocal[8][4-11]. +# Local arrays can not be access directly in the script, +# but they are printed out to file dump.blocal + +variable nrep index 1 +variable a index 3.316 +variable ngrid index 2 + +units metal +atom_modify map hash + +# generate the box and atom positions using a BCC lattice + +variable nx equal ${nrep} +variable ny equal ${nrep} +variable nz equal ${nrep} + +boundary p p p + +lattice custom $a & + a1 1 0 0 & + a2 0 1 0 & + a3 0 0 1 & + basis 0 0 0 & + basis 0.5 0.5 0.5 & + +region box block 0 ${nx} 0 ${ny} 0 ${nz} +create_box 1 box +create_atoms 1 box + +mass 1 180.88 + +# define atom compute and grid compute + +group snapgroup type 1 +variable twojmax equal 2 +variable rcutfac equal 4.67637 +variable rfac0 equal 0.99363 +variable rmin0 equal 0 +variable wj equal 1 +variable radelem equal 0.5 +variable bzero equal 0 +variable quadratic equal 0 +variable switch equal 1 + +variable snap_options string & + "${rcutfac} ${rfac0} ${twojmax} ${radelem} & + ${wj} rmin0 ${rmin0} quadraticflag ${quadratic} & + bzeroflag ${bzero} switchflag ${switch}" + +# build zero potential to satisfy compute sna/atom + +pair_style zero ${rcutfac} +pair_coeff * * + +# define atom and grid computes + +compute b all sna/atom ${snap_options} +compute mygrid all sna/grid grid ${ngrid} ${ngrid} ${ngrid} & + ${snap_options} +compute mygridlocal all sna/grid/local grid ${ngrid} ${ngrid} ${ngrid} & + ${snap_options} + +# define output + +variable B5atom equal c_b[2][5] +variable B5grid equal c_mygrid[8][8] + +variable rmse_global equal "sqrt( & + (c_mygrid[8][1] - x[2])^2 + & + (c_mygrid[8][2] - y[2])^2 + & + (c_mygrid[8][3] - z[2])^2 + & + (c_mygrid[8][4] - c_b[2][1])^2 + & + (c_mygrid[8][5] - c_b[2][2])^2 + & + (c_mygrid[8][6] - c_b[2][3])^2 + & + (c_mygrid[8][7] - c_b[2][4])^2 + & + (c_mygrid[8][8] - c_b[2][5])^2 & + )" + +thermo_style custom step v_B5atom v_B5grid v_rmse_global + +# this is the only way to view the local grid + +dump 1 all local 1000 dump.blocal c_mygridlocal[*] +dump 2 all custom 1000 dump.batom id x y z c_b[*] + +# run + +run 0 + diff --git a/examples/snap/in.grid.tri b/examples/snap/in.grid.tri index f375c18c42..5283957eb8 100644 --- a/examples/snap/in.grid.tri +++ b/examples/snap/in.grid.tri @@ -1,4 +1,5 @@ -# Demonstrate bispectrum computes for triclinic cell +# Demonstrate calculation of SNAP bispectrum +# descriptors on a grid for triclinic cell # This triclinic cell has 6 times the volume of the single # unit cell used by in.grid @@ -6,35 +7,37 @@ # with each unit cell containing 2 atoms and the # reduced lattice vectors are [1 0 0], [1 1 0], and [1 1 1]. # The grid is listed in x-fastest order -# CORRECTNESS: thermo output for c_mygrid[*][7] should contain -# the same 2 values that appear in c_mygrid[*][7] for in.grid, -# 7.0663376 and 13.808803, corresponding to atom and insterstitial sites, -# respectively, and with occurrences 12 and 36, respectively. + +# CORRECTNESS: The atom positions coincide with certain +# gridpoints, so c_b[1][1-5] should match c_mygrid[1][4-8] +# and c_b[7][1-5] should match c_mygrid[13][4-8]. +# Local arrays can not be access directly in the script, +# but they are printed out to file dump.blocal.tri # Initialize simulation -variable nsteps index 0 -variable nrep index 1 -variable a index 3.316 -variable ngrid index 4 +variable nrep index 1 +variable a index 3.316 +variable ngrid index 2 -variable ngridx equal 3*${ngrid} -variable ngridy equal 2*${ngrid} -variable ngridz equal 1*${ngrid} +variable nrepx equal 3*${nrep} +variable nrepy equal 2*${nrep} +variable nrepz equal 1*${nrep} -variable nrepx equal 1*${nrep} -variable nrepy equal 1*${nrep} -variable nrepz equal 1*${nrep} +variable ngridx equal 3*${ngrid} +variable ngridy equal 2*${ngrid} +variable ngridz equal 1*${ngrid} -units metal +units metal +atom_modify map hash sort 0 0 # generate the box and atom positions using a BCC lattice -variable nx equal ${nrepx} -variable ny equal ${nrepy} -variable nz equal ${nrepz} +variable nx equal ${nrepx} +variable ny equal ${nrepy} +variable nz equal ${nrepz} -boundary p p p +boundary p p p lattice custom $a & a1 1 0 0 & @@ -42,20 +45,16 @@ lattice custom $a & a3 1 1 1 & basis 0 0 0 & basis 0.0 0.0 0.5 & -# origin 0.25 0.25 0.25 + spacing 1 1 1 box tilt large region box prism 0 ${nx} 0 ${ny} 0 ${nz} ${ny} ${nz} ${nz} create_box 1 box create_atoms 1 box -mass 1 180.88 +mass 1 180.88 -# choose potential - -include Ta06A.snap - -# define grid compute and atom compute +# define atom compute and grid compute group snapgroup type 1 variable twojmax equal 2 @@ -65,71 +64,51 @@ variable rmin0 equal 0 variable wj equal 1 variable radelem equal 0.5 variable bzero equal 0 -variable quad equal 0 +variable quadratic equal 0 variable switch equal 1 -compute b all sna/atom & - ${rcutfac} ${rfac0} ${twojmax} ${radelem} & - ${wj} rmin0 ${rmin0} bzeroflag ${bzero} & - quadraticflag ${quad} switchflag ${switch} +variable snap_options string & + "${rcutfac} ${rfac0} ${twojmax} ${radelem} & + ${wj} rmin0 ${rmin0} quadraticflag ${quadratic} & + bzeroflag ${bzero} switchflag ${switch}" -compute mygrid all sna/grid grid ${ngridx} ${ngridy} ${ngridz} & - ${rcutfac} ${rfac0} ${twojmax} ${radelem} & - ${wj} rmin0 ${rmin0} bzeroflag ${bzero} & - quadraticflag ${quad} switchflag ${switch} +# build zero potential to satisfy compute sna/atom + +pair_style zero ${rcutfac} +pair_coeff * * + +# define atom and grid computes + +compute b all sna/atom ${snap_options} +compute mygrid all sna/grid grid ${ngridx} ${ngridy} ${ngridz} & + ${snap_options} +compute mygridlocal all sna/grid/local grid ${ngridx} ${ngridy} ${ngridz} & + ${snap_options} # define output -# mygrid is ngrid by (3+nbis) = 384x8 +variable B5atom equal c_b[7][5] +variable B5grid equal c_mygrid[13][8] -thermo_style custom step temp ke pe vol & - c_mygrid[1][7] c_mygrid[2][7] c_mygrid[3][7] c_mygrid[4][7] c_mygrid[5][7] c_mygrid[6][7] c_mygrid[7][7] c_mygrid[8][7] c_mygrid[9][7] & - c_mygrid[10][7] c_mygrid[11][7] c_mygrid[12][7] c_mygrid[13][7] c_mygrid[14][7] c_mygrid[15][7] c_mygrid[16][7] c_mygrid[17][7] c_mygrid[18][7] c_mygrid[19][7] & - c_mygrid[20][7] c_mygrid[21][7] c_mygrid[22][7] c_mygrid[23][7] c_mygrid[24][7] c_mygrid[25][7] c_mygrid[26][7] c_mygrid[27][7] c_mygrid[28][7] c_mygrid[29][7] & - c_mygrid[30][7] c_mygrid[31][7] c_mygrid[32][7] c_mygrid[33][7] c_mygrid[34][7] c_mygrid[35][7] c_mygrid[36][7] c_mygrid[37][7] c_mygrid[38][7] c_mygrid[39][7] & - c_mygrid[40][7] c_mygrid[41][7] c_mygrid[42][7] c_mygrid[43][7] c_mygrid[44][7] c_mygrid[45][7] c_mygrid[46][7] c_mygrid[47][7] c_mygrid[48][7] c_mygrid[49][7] & - c_mygrid[50][7] c_mygrid[51][7] c_mygrid[52][7] c_mygrid[53][7] c_mygrid[54][7] c_mygrid[55][7] c_mygrid[56][7] c_mygrid[57][7] c_mygrid[58][7] c_mygrid[59][7] & - c_mygrid[60][7] c_mygrid[61][7] c_mygrid[62][7] c_mygrid[63][7] c_mygrid[64][7] c_mygrid[65][7] c_mygrid[66][7] c_mygrid[67][7] c_mygrid[68][7] c_mygrid[69][7] & - c_mygrid[70][7] c_mygrid[71][7] c_mygrid[72][7] c_mygrid[73][7] c_mygrid[74][7] c_mygrid[75][7] c_mygrid[76][7] c_mygrid[77][7] c_mygrid[78][7] c_mygrid[79][7] & - c_mygrid[80][7] c_mygrid[81][7] c_mygrid[82][7] c_mygrid[83][7] c_mygrid[84][7] c_mygrid[85][7] c_mygrid[86][7] c_mygrid[87][7] c_mygrid[88][7] c_mygrid[89][7] & - c_mygrid[90][7] c_mygrid[91][7] c_mygrid[92][7] c_mygrid[93][7] c_mygrid[94][7] c_mygrid[95][7] c_mygrid[96][7] c_mygrid[97][7] c_mygrid[98][7] c_mygrid[99][7] & - c_mygrid[100][7] c_mygrid[101][7] c_mygrid[102][7] c_mygrid[103][7] c_mygrid[104][7] c_mygrid[105][7] c_mygrid[106][7] c_mygrid[107][7] c_mygrid[108][7] c_mygrid[109][7] & - c_mygrid[110][7] c_mygrid[111][7] c_mygrid[112][7] c_mygrid[113][7] c_mygrid[114][7] c_mygrid[115][7] c_mygrid[116][7] c_mygrid[117][7] c_mygrid[118][7] c_mygrid[119][7] & - c_mygrid[120][7] c_mygrid[121][7] c_mygrid[122][7] c_mygrid[123][7] c_mygrid[124][7] c_mygrid[125][7] c_mygrid[126][7] c_mygrid[127][7] c_mygrid[128][7] c_mygrid[129][7] & - c_mygrid[130][7] c_mygrid[131][7] c_mygrid[132][7] c_mygrid[133][7] c_mygrid[134][7] c_mygrid[135][7] c_mygrid[136][7] c_mygrid[137][7] c_mygrid[138][7] c_mygrid[139][7] & - c_mygrid[140][7] c_mygrid[141][7] c_mygrid[142][7] c_mygrid[143][7] c_mygrid[144][7] c_mygrid[145][7] c_mygrid[146][7] c_mygrid[147][7] c_mygrid[148][7] c_mygrid[149][7] & - c_mygrid[150][7] c_mygrid[151][7] c_mygrid[152][7] c_mygrid[153][7] c_mygrid[154][7] c_mygrid[155][7] c_mygrid[156][7] c_mygrid[157][7] c_mygrid[158][7] c_mygrid[159][7] & - c_mygrid[160][7] c_mygrid[161][7] c_mygrid[162][7] c_mygrid[163][7] c_mygrid[164][7] c_mygrid[165][7] c_mygrid[166][7] c_mygrid[167][7] c_mygrid[168][7] c_mygrid[169][7] & - c_mygrid[170][7] c_mygrid[171][7] c_mygrid[172][7] c_mygrid[173][7] c_mygrid[174][7] c_mygrid[175][7] c_mygrid[176][7] c_mygrid[177][7] c_mygrid[178][7] c_mygrid[179][7] & - c_mygrid[180][7] c_mygrid[181][7] c_mygrid[182][7] c_mygrid[183][7] c_mygrid[184][7] c_mygrid[185][7] c_mygrid[186][7] c_mygrid[187][7] c_mygrid[188][7] c_mygrid[189][7] & - c_mygrid[190][7] c_mygrid[191][7] c_mygrid[192][7] c_mygrid[193][7] c_mygrid[194][7] c_mygrid[195][7] c_mygrid[196][7] c_mygrid[197][7] c_mygrid[198][7] c_mygrid[199][7] & - c_mygrid[200][7] c_mygrid[201][7] c_mygrid[202][7] c_mygrid[203][7] c_mygrid[204][7] c_mygrid[205][7] c_mygrid[206][7] c_mygrid[207][7] c_mygrid[208][7] c_mygrid[209][7] & - c_mygrid[210][7] c_mygrid[211][7] c_mygrid[212][7] c_mygrid[213][7] c_mygrid[214][7] c_mygrid[215][7] c_mygrid[216][7] c_mygrid[217][7] c_mygrid[218][7] c_mygrid[219][7] & - c_mygrid[220][7] c_mygrid[221][7] c_mygrid[222][7] c_mygrid[223][7] c_mygrid[224][7] c_mygrid[225][7] c_mygrid[226][7] c_mygrid[227][7] c_mygrid[228][7] c_mygrid[229][7] & - c_mygrid[230][7] c_mygrid[231][7] c_mygrid[232][7] c_mygrid[233][7] c_mygrid[234][7] c_mygrid[235][7] c_mygrid[236][7] c_mygrid[237][7] c_mygrid[238][7] c_mygrid[239][7] & - c_mygrid[240][7] c_mygrid[241][7] c_mygrid[242][7] c_mygrid[243][7] c_mygrid[244][7] c_mygrid[245][7] c_mygrid[246][7] c_mygrid[247][7] c_mygrid[248][7] c_mygrid[249][7] & - c_mygrid[250][7] c_mygrid[251][7] c_mygrid[252][7] c_mygrid[253][7] c_mygrid[254][7] c_mygrid[255][7] c_mygrid[256][7] c_mygrid[257][7] c_mygrid[258][7] c_mygrid[259][7] & - c_mygrid[260][7] c_mygrid[261][7] c_mygrid[262][7] c_mygrid[263][7] c_mygrid[264][7] c_mygrid[265][7] c_mygrid[266][7] c_mygrid[267][7] c_mygrid[268][7] c_mygrid[269][7] & - c_mygrid[270][7] c_mygrid[271][7] c_mygrid[272][7] c_mygrid[273][7] c_mygrid[274][7] c_mygrid[275][7] c_mygrid[276][7] c_mygrid[277][7] c_mygrid[278][7] c_mygrid[279][7] & - c_mygrid[280][7] c_mygrid[281][7] c_mygrid[282][7] c_mygrid[283][7] c_mygrid[284][7] c_mygrid[285][7] c_mygrid[286][7] c_mygrid[287][7] c_mygrid[288][7] c_mygrid[289][7] & - c_mygrid[290][7] c_mygrid[291][7] c_mygrid[292][7] c_mygrid[293][7] c_mygrid[294][7] c_mygrid[295][7] c_mygrid[296][7] c_mygrid[297][7] c_mygrid[298][7] c_mygrid[299][7] & - c_mygrid[300][7] c_mygrid[301][7] c_mygrid[302][7] c_mygrid[303][7] c_mygrid[304][7] c_mygrid[305][7] c_mygrid[306][7] c_mygrid[307][7] c_mygrid[308][7] c_mygrid[309][7] & - c_mygrid[310][7] c_mygrid[311][7] c_mygrid[312][7] c_mygrid[313][7] c_mygrid[314][7] c_mygrid[315][7] c_mygrid[316][7] c_mygrid[317][7] c_mygrid[318][7] c_mygrid[319][7] & - c_mygrid[320][7] c_mygrid[321][7] c_mygrid[322][7] c_mygrid[323][7] c_mygrid[324][7] c_mygrid[325][7] c_mygrid[326][7] c_mygrid[327][7] c_mygrid[328][7] c_mygrid[329][7] & - c_mygrid[330][7] c_mygrid[331][7] c_mygrid[332][7] c_mygrid[333][7] c_mygrid[334][7] c_mygrid[335][7] c_mygrid[336][7] c_mygrid[337][7] c_mygrid[338][7] c_mygrid[339][7] & - c_mygrid[340][7] c_mygrid[341][7] c_mygrid[342][7] c_mygrid[343][7] c_mygrid[344][7] c_mygrid[345][7] c_mygrid[346][7] c_mygrid[347][7] c_mygrid[348][7] c_mygrid[349][7] & - c_mygrid[350][7] c_mygrid[351][7] c_mygrid[352][7] c_mygrid[353][7] c_mygrid[354][7] c_mygrid[355][7] c_mygrid[356][7] c_mygrid[357][7] c_mygrid[358][7] c_mygrid[359][7] & - c_mygrid[360][7] c_mygrid[361][7] c_mygrid[362][7] c_mygrid[363][7] c_mygrid[364][7] c_mygrid[365][7] c_mygrid[366][7] c_mygrid[367][7] c_mygrid[368][7] c_mygrid[369][7] & - c_mygrid[370][7] c_mygrid[371][7] c_mygrid[372][7] c_mygrid[373][7] c_mygrid[374][7] c_mygrid[375][7] c_mygrid[376][7] c_mygrid[377][7] c_mygrid[378][7] c_mygrid[379][7] & - c_mygrid[380][7] c_mygrid[381][7] c_mygrid[382][7] c_mygrid[383][7] c_mygrid[384][7] +# do not compare x,y,z because assignment of ids +# to atoms is not unnique for different processor grids -thermo_modify norm yes +variable rmse_global equal "sqrt( & + (c_mygrid[13][4] - c_b[7][1])^2 + & + (c_mygrid[13][5] - c_b[7][2])^2 + & + (c_mygrid[13][6] - c_b[7][3])^2 + & + (c_mygrid[13][7] - c_b[7][4])^2 + & + (c_mygrid[13][8] - c_b[7][5])^2 & + )" -dump mydump_b all custom 1000 dump_b id c_b[*] +thermo_style custom step v_B5atom v_B5grid v_rmse_global + +# this is the only way to view the local grid + +dump 1 all local 1000 dump.blocal.tri c_mygridlocal[*] +dump 2 all custom 1000 dump.batom.tri id x y z c_b[*] # run -run 0 - - +run 0 diff --git a/examples/snap/log.15Jun22.grid.snap.g++.1 b/examples/snap/log.15Jun22.grid.snap.g++.1 new file mode 100644 index 0000000000..71b884d1b6 --- /dev/null +++ b/examples/snap/log.15Jun22.grid.snap.g++.1 @@ -0,0 +1,167 @@ +LAMMPS (28 Jul 2021) +# Demonstrate calculation of SNAP bispectrum descriptors on a grid + +# CORRECTNESS: The two atom positions coincide with two of +# the gridpoints, so c_b[2][1-5] should match c_mygrid[8][4-8]. +# The same is true for compute grid/local c_mygridlocal[8][4-11]. +# Local arrays can not be access directly in the script, +# but they are printed out to file dump.blocal + +variable nrep index 1 +variable a index 3.316 +variable ngrid index 2 + +units metal +atom_modify map hash + +# generate the box and atom positions using a BCC lattice + +variable nx equal ${nrep} +variable nx equal 1 +variable ny equal ${nrep} +variable ny equal 1 +variable nz equal ${nrep} +variable nz equal 1 + +boundary p p p + +lattice custom $a a1 1 0 0 a2 0 1 0 a3 0 0 1 basis 0 0 0 basis 0.5 0.5 0.5 +lattice custom 3.316 a1 1 0 0 a2 0 1 0 a3 0 0 1 basis 0 0 0 basis 0.5 0.5 0.5 +Lattice spacing in x,y,z = 3.3160000 3.3160000 3.3160000 +region box block 0 ${nx} 0 ${ny} 0 ${nz} +region box block 0 1 0 ${ny} 0 ${nz} +region box block 0 1 0 1 0 ${nz} +region box block 0 1 0 1 0 1 +create_box 1 box +Created orthogonal box = (0.0000000 0.0000000 0.0000000) to (3.3160000 3.3160000 3.3160000) + 1 by 1 by 1 MPI processor grid +create_atoms 1 box +Created 2 atoms + using lattice units in orthogonal box = (0.0000000 0.0000000 0.0000000) to (3.3160000 3.3160000 3.3160000) + create_atoms CPU = 0.000 seconds + +mass 1 180.88 + +# define atom compute and grid compute + +group snapgroup type 1 +2 atoms in group snapgroup +variable twojmax equal 2 +variable rcutfac equal 4.67637 +variable rfac0 equal 0.99363 +variable rmin0 equal 0 +variable wj equal 1 +variable radelem equal 0.5 +variable bzero equal 0 +variable quadratic equal 0 +variable switch equal 1 + +variable snap_options string "${rcutfac} ${rfac0} ${twojmax} ${radelem} ${wj} rmin0 ${rmin0} quadraticflag ${quadratic} bzeroflag ${bzero} switchflag ${switch}" +4.67637 ${rfac0} ${twojmax} ${radelem} ${wj} rmin0 ${rmin0} quadraticflag ${quadratic} bzeroflag ${bzero} switchflag ${switch} +4.67637 0.99363 ${twojmax} ${radelem} ${wj} rmin0 ${rmin0} quadraticflag ${quadratic} bzeroflag ${bzero} switchflag ${switch} +4.67637 0.99363 2 ${radelem} ${wj} rmin0 ${rmin0} quadraticflag ${quadratic} bzeroflag ${bzero} switchflag ${switch} +4.67637 0.99363 2 0.5 ${wj} rmin0 ${rmin0} quadraticflag ${quadratic} bzeroflag ${bzero} switchflag ${switch} +4.67637 0.99363 2 0.5 1 rmin0 ${rmin0} quadraticflag ${quadratic} bzeroflag ${bzero} switchflag ${switch} +4.67637 0.99363 2 0.5 1 rmin0 0 quadraticflag ${quadratic} bzeroflag ${bzero} switchflag ${switch} +4.67637 0.99363 2 0.5 1 rmin0 0 quadraticflag 0 bzeroflag ${bzero} switchflag ${switch} +4.67637 0.99363 2 0.5 1 rmin0 0 quadraticflag 0 bzeroflag 0 switchflag ${switch} +4.67637 0.99363 2 0.5 1 rmin0 0 quadraticflag 0 bzeroflag 0 switchflag 1 + +# build zero potential to satisfy compute sna/atom + +pair_style zero ${rcutfac} +pair_style zero 4.67637 +pair_coeff * * + +# define atom and grid computes + +compute b all sna/atom ${snap_options} +compute b all sna/atom 4.67637 0.99363 2 0.5 1 rmin0 0 quadraticflag 0 bzeroflag 0 switchflag 1 +compute mygrid all sna/grid grid ${ngrid} ${ngrid} ${ngrid} ${snap_options} +compute mygrid all sna/grid grid 2 ${ngrid} ${ngrid} ${snap_options} +compute mygrid all sna/grid grid 2 2 ${ngrid} ${snap_options} +compute mygrid all sna/grid grid 2 2 2 ${snap_options} +compute mygrid all sna/grid grid 2 2 2 4.67637 0.99363 2 0.5 1 rmin0 0 quadraticflag 0 bzeroflag 0 switchflag 1 +compute mygridlocal all sna/grid/local grid ${ngrid} ${ngrid} ${ngrid} ${snap_options} +compute mygridlocal all sna/grid/local grid 2 ${ngrid} ${ngrid} ${snap_options} +compute mygridlocal all sna/grid/local grid 2 2 ${ngrid} ${snap_options} +compute mygridlocal all sna/grid/local grid 2 2 2 ${snap_options} +compute mygridlocal all sna/grid/local grid 2 2 2 4.67637 0.99363 2 0.5 1 rmin0 0 quadraticflag 0 bzeroflag 0 switchflag 1 + +# define output + +variable B5atom equal c_b[2][5] +variable B5grid equal c_mygrid[8][8] + +variable rmse_global equal "sqrt( (c_mygrid[8][1] - x[2])^2 + (c_mygrid[8][2] - y[2])^2 + (c_mygrid[8][3] - z[2])^2 + (c_mygrid[8][4] - c_b[2][1])^2 + (c_mygrid[8][5] - c_b[2][2])^2 + (c_mygrid[8][6] - c_b[2][3])^2 + (c_mygrid[8][7] - c_b[2][4])^2 + (c_mygrid[8][8] - c_b[2][5])^2 )" + +thermo_style custom step v_B5atom v_B5grid v_rmse_global + +# this is the only way to view the local grid + +dump 1 all local 1000 dump.blocal c_mygridlocal[*] +dump 2 all custom 1000 dump.batom id x y z c_b[*] + +# run + +run 0 +WARNING: No fixes defined, atoms won't move (src/verlet.cpp:55) +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 6.67637 + ghost atom cutoff = 6.67637 + binsize = 3.338185, bins = 1 1 1 + 4 neighbor lists, perpetual/occasional/extra = 1 3 0 + (1) pair zero, perpetual + attributes: half, newton on + pair build: half/bin/atomonly/newton + stencil: half/bin/3d + bin: standard + (2) compute sna/atom, occasional + attributes: full, newton on + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard + (3) compute sna/grid, occasional + attributes: full, newton on + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard + (4) compute sna/grid/local, occasional + attributes: full, newton on + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 8.384 | 8.384 | 8.384 Mbytes +Step v_B5atom v_B5grid v_rmse_global + 0 1.0427295 1.0427295 0 +Loop time of 1e-06 on 1 procs for 0 steps with 2 atoms + +100.0% CPU use with 1 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0 | 0 | 0 | 0.0 | 0.00 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0 | 0 | 0 | 0.0 | 0.00 +Output | 0 | 0 | 0 | 0.0 | 0.00 +Modify | 0 | 0 | 0 | 0.0 | 0.00 +Other | | 1e-06 | | |100.00 + +Nlocal: 2.00000 ave 2 max 2 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 339.000 ave 339 max 339 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 64.0000 ave 64 max 64 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +FullNghs: 128.000 ave 128 max 128 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 128 +Ave neighs/atom = 64.000000 +Neighbor list builds = 0 +Dangerous builds = 0 + +Total wall time: 0:00:00 diff --git a/examples/snap/log.15Jun22.grid.snap.g++.4 b/examples/snap/log.15Jun22.grid.snap.g++.4 new file mode 100644 index 0000000000..80761fc395 --- /dev/null +++ b/examples/snap/log.15Jun22.grid.snap.g++.4 @@ -0,0 +1,168 @@ +LAMMPS (28 Jul 2021) +# Demonstrate calculation of SNAP bispectrum descriptors on a grid + +# CORRECTNESS: The two atom positions coincide with two of +# the gridpoints, so c_b[2][1-5] should match c_mygrid[8][4-8]. +# The same is true for compute grid/local c_mygridlocal[8][4-11]. +# Local arrays can not be access directly in the script, +# but they are printed out to file dump.blocal + +variable nrep index 1 +variable a index 3.316 +variable ngrid index 2 + +units metal +atom_modify map hash + +# generate the box and atom positions using a BCC lattice + +variable nx equal ${nrep} +variable nx equal 1 +variable ny equal ${nrep} +variable ny equal 1 +variable nz equal ${nrep} +variable nz equal 1 + +boundary p p p + +lattice custom $a a1 1 0 0 a2 0 1 0 a3 0 0 1 basis 0 0 0 basis 0.5 0.5 0.5 +lattice custom 3.316 a1 1 0 0 a2 0 1 0 a3 0 0 1 basis 0 0 0 basis 0.5 0.5 0.5 +Lattice spacing in x,y,z = 3.3160000 3.3160000 3.3160000 +region box block 0 ${nx} 0 ${ny} 0 ${nz} +region box block 0 1 0 ${ny} 0 ${nz} +region box block 0 1 0 1 0 ${nz} +region box block 0 1 0 1 0 1 +create_box 1 box +Created orthogonal box = (0.0000000 0.0000000 0.0000000) to (3.3160000 3.3160000 3.3160000) + 1 by 2 by 2 MPI processor grid +create_atoms 1 box +Created 2 atoms + using lattice units in orthogonal box = (0.0000000 0.0000000 0.0000000) to (3.3160000 3.3160000 3.3160000) + create_atoms CPU = 0.001 seconds + +mass 1 180.88 + +# define atom compute and grid compute + +group snapgroup type 1 +2 atoms in group snapgroup +variable twojmax equal 2 +variable rcutfac equal 4.67637 +variable rfac0 equal 0.99363 +variable rmin0 equal 0 +variable wj equal 1 +variable radelem equal 0.5 +variable bzero equal 0 +variable quadratic equal 0 +variable switch equal 1 + +variable snap_options string "${rcutfac} ${rfac0} ${twojmax} ${radelem} ${wj} rmin0 ${rmin0} quadraticflag ${quadratic} bzeroflag ${bzero} switchflag ${switch}" +4.67637 ${rfac0} ${twojmax} ${radelem} ${wj} rmin0 ${rmin0} quadraticflag ${quadratic} bzeroflag ${bzero} switchflag ${switch} +4.67637 0.99363 ${twojmax} ${radelem} ${wj} rmin0 ${rmin0} quadraticflag ${quadratic} bzeroflag ${bzero} switchflag ${switch} +4.67637 0.99363 2 ${radelem} ${wj} rmin0 ${rmin0} quadraticflag ${quadratic} bzeroflag ${bzero} switchflag ${switch} +4.67637 0.99363 2 0.5 ${wj} rmin0 ${rmin0} quadraticflag ${quadratic} bzeroflag ${bzero} switchflag ${switch} +4.67637 0.99363 2 0.5 1 rmin0 ${rmin0} quadraticflag ${quadratic} bzeroflag ${bzero} switchflag ${switch} +4.67637 0.99363 2 0.5 1 rmin0 0 quadraticflag ${quadratic} bzeroflag ${bzero} switchflag ${switch} +4.67637 0.99363 2 0.5 1 rmin0 0 quadraticflag 0 bzeroflag ${bzero} switchflag ${switch} +4.67637 0.99363 2 0.5 1 rmin0 0 quadraticflag 0 bzeroflag 0 switchflag ${switch} +4.67637 0.99363 2 0.5 1 rmin0 0 quadraticflag 0 bzeroflag 0 switchflag 1 + +# build zero potential to satisfy compute sna/atom + +pair_style zero ${rcutfac} +pair_style zero 4.67637 +pair_coeff * * + +# define atom and grid computes + +compute b all sna/atom ${snap_options} +compute b all sna/atom 4.67637 0.99363 2 0.5 1 rmin0 0 quadraticflag 0 bzeroflag 0 switchflag 1 +compute mygrid all sna/grid grid ${ngrid} ${ngrid} ${ngrid} ${snap_options} +compute mygrid all sna/grid grid 2 ${ngrid} ${ngrid} ${snap_options} +compute mygrid all sna/grid grid 2 2 ${ngrid} ${snap_options} +compute mygrid all sna/grid grid 2 2 2 ${snap_options} +compute mygrid all sna/grid grid 2 2 2 4.67637 0.99363 2 0.5 1 rmin0 0 quadraticflag 0 bzeroflag 0 switchflag 1 +compute mygridlocal all sna/grid/local grid ${ngrid} ${ngrid} ${ngrid} ${snap_options} +compute mygridlocal all sna/grid/local grid 2 ${ngrid} ${ngrid} ${snap_options} +compute mygridlocal all sna/grid/local grid 2 2 ${ngrid} ${snap_options} +compute mygridlocal all sna/grid/local grid 2 2 2 ${snap_options} +compute mygridlocal all sna/grid/local grid 2 2 2 4.67637 0.99363 2 0.5 1 rmin0 0 quadraticflag 0 bzeroflag 0 switchflag 1 + +# define output + +variable B5atom equal c_b[2][5] +variable B5grid equal c_mygrid[8][8] + +variable rmse_global equal "sqrt( (c_mygrid[8][1] - x[2])^2 + (c_mygrid[8][2] - y[2])^2 + (c_mygrid[8][3] - z[2])^2 + (c_mygrid[8][4] - c_b[2][1])^2 + (c_mygrid[8][5] - c_b[2][2])^2 + (c_mygrid[8][6] - c_b[2][3])^2 + (c_mygrid[8][7] - c_b[2][4])^2 + (c_mygrid[8][8] - c_b[2][5])^2 )" + +thermo_style custom step v_B5atom v_B5grid v_rmse_global + +# this is the only way to view the local grid + +dump 1 all local 1000 dump.blocal c_mygridlocal[*] +dump 2 all custom 1000 dump.batom id x y z c_b[*] + +# run + +run 0 +WARNING: No fixes defined, atoms won't move (src/verlet.cpp:55) +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 6.67637 + ghost atom cutoff = 6.67637 + binsize = 3.338185, bins = 1 1 1 + 4 neighbor lists, perpetual/occasional/extra = 1 3 0 + (1) pair zero, perpetual + attributes: half, newton on + pair build: half/bin/atomonly/newton + stencil: half/bin/3d + bin: standard + (2) compute sna/atom, occasional + attributes: full, newton on + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard + (3) compute sna/grid, occasional + attributes: full, newton on + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard + (4) compute sna/grid/local, occasional + attributes: full, newton on + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard +WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (src/domain.cpp:964) +Per MPI rank memory allocation (min/avg/max) = 7.381 | 7.889 | 8.397 Mbytes +Step v_B5atom v_B5grid v_rmse_global + 0 1.0427295 1.0427295 0 +Loop time of 1.5e-06 on 4 procs for 0 steps with 2 atoms + +83.3% CPU use with 4 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0 | 0 | 0 | 0.0 | 0.00 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0 | 0 | 0 | 0.0 | 0.00 +Output | 0 | 0 | 0 | 0.0 | 0.00 +Modify | 0 | 0 | 0 | 0.0 | 0.00 +Other | | 1.5e-06 | | |100.00 + +Nlocal: 0.500000 ave 1 max 0 min +Histogram: 2 0 0 0 0 0 0 0 0 2 +Nghost: 274.500 ave 275 max 274 min +Histogram: 2 0 0 0 0 0 0 0 0 2 +Neighs: 16.0000 ave 40 max 0 min +Histogram: 2 0 0 0 0 0 1 0 0 1 +FullNghs: 32.0000 ave 64 max 0 min +Histogram: 2 0 0 0 0 0 0 0 0 2 + +Total # of neighbors = 128 +Ave neighs/atom = 64.000000 +Neighbor list builds = 0 +Dangerous builds = 0 + +Total wall time: 0:00:00 diff --git a/examples/snap/log.15Jun22.grid.tri.g++.1 b/examples/snap/log.15Jun22.grid.tri.g++.1 new file mode 100644 index 0000000000..c261154367 --- /dev/null +++ b/examples/snap/log.15Jun22.grid.tri.g++.1 @@ -0,0 +1,200 @@ +LAMMPS (28 Jul 2021) +# Demonstrate calculation of SNAP bispectrum +# descriptors on a grid for triclinic cell + +# This triclinic cell has 6 times the volume of the single +# unit cell used by in.grid +# and contains 12 atoms. It is a 3x2x1 supercell +# with each unit cell containing 2 atoms and the +# reduced lattice vectors are [1 0 0], [1 1 0], and [1 1 1]. +# The grid is listed in x-fastest order + +# CORRECTNESS: The atom positions coincide with certain +# gridpoints, so c_b[1][1-5] should match c_mygrid[1][4-8] +# and c_b[7][1-5] should match c_mygrid[13][4-8]. +# Local arrays can not be access directly in the script, +# but they are printed out to file dump.blocal.tri + +# Initialize simulation + +variable nrep index 1 +variable a index 3.316 +variable ngrid index 2 + +variable nrepx equal 3*${nrep} +variable nrepx equal 3*1 +variable nrepy equal 2*${nrep} +variable nrepy equal 2*1 +variable nrepz equal 1*${nrep} +variable nrepz equal 1*1 + +variable ngridx equal 3*${ngrid} +variable ngridx equal 3*2 +variable ngridy equal 2*${ngrid} +variable ngridy equal 2*2 +variable ngridz equal 1*${ngrid} +variable ngridz equal 1*2 + +units metal +atom_modify map hash sort 0 0 + +# generate the box and atom positions using a BCC lattice + +variable nx equal ${nrepx} +variable nx equal 3 +variable ny equal ${nrepy} +variable ny equal 2 +variable nz equal ${nrepz} +variable nz equal 1 + +boundary p p p + +lattice custom $a a1 1 0 0 a2 1 1 0 a3 1 1 1 basis 0 0 0 basis 0.0 0.0 0.5 spacing 1 1 1 +lattice custom 3.316 a1 1 0 0 a2 1 1 0 a3 1 1 1 basis 0 0 0 basis 0.0 0.0 0.5 spacing 1 1 1 +Lattice spacing in x,y,z = 3.3160000 3.3160000 3.3160000 + +box tilt large +region box prism 0 ${nx} 0 ${ny} 0 ${nz} ${ny} ${nz} ${nz} +region box prism 0 3 0 ${ny} 0 ${nz} ${ny} ${nz} ${nz} +region box prism 0 3 0 2 0 ${nz} ${ny} ${nz} ${nz} +region box prism 0 3 0 2 0 1 ${ny} ${nz} ${nz} +region box prism 0 3 0 2 0 1 2 ${nz} ${nz} +region box prism 0 3 0 2 0 1 2 1 ${nz} +region box prism 0 3 0 2 0 1 2 1 1 +create_box 1 box +Created triclinic box = (0.0000000 0.0000000 0.0000000) to (9.9480000 6.6320000 3.3160000) with tilt (6.6320000 3.3160000 3.3160000) +WARNING: Triclinic box skew is large (src/domain.cpp:219) + 1 by 1 by 1 MPI processor grid +create_atoms 1 box +Created 12 atoms + using lattice units in triclinic box = (0.0000000 0.0000000 0.0000000) to (9.9480000 6.6320000 3.3160000) with tilt (6.6320000 3.3160000 3.3160000) + create_atoms CPU = 0.001 seconds + +mass 1 180.88 + +# define atom compute and grid compute + +group snapgroup type 1 +12 atoms in group snapgroup +variable twojmax equal 2 +variable rcutfac equal 4.67637 +variable rfac0 equal 0.99363 +variable rmin0 equal 0 +variable wj equal 1 +variable radelem equal 0.5 +variable bzero equal 0 +variable quadratic equal 0 +variable switch equal 1 + +variable snap_options string "${rcutfac} ${rfac0} ${twojmax} ${radelem} ${wj} rmin0 ${rmin0} quadraticflag ${quadratic} bzeroflag ${bzero} switchflag ${switch}" +4.67637 ${rfac0} ${twojmax} ${radelem} ${wj} rmin0 ${rmin0} quadraticflag ${quadratic} bzeroflag ${bzero} switchflag ${switch} +4.67637 0.99363 ${twojmax} ${radelem} ${wj} rmin0 ${rmin0} quadraticflag ${quadratic} bzeroflag ${bzero} switchflag ${switch} +4.67637 0.99363 2 ${radelem} ${wj} rmin0 ${rmin0} quadraticflag ${quadratic} bzeroflag ${bzero} switchflag ${switch} +4.67637 0.99363 2 0.5 ${wj} rmin0 ${rmin0} quadraticflag ${quadratic} bzeroflag ${bzero} switchflag ${switch} +4.67637 0.99363 2 0.5 1 rmin0 ${rmin0} quadraticflag ${quadratic} bzeroflag ${bzero} switchflag ${switch} +4.67637 0.99363 2 0.5 1 rmin0 0 quadraticflag ${quadratic} bzeroflag ${bzero} switchflag ${switch} +4.67637 0.99363 2 0.5 1 rmin0 0 quadraticflag 0 bzeroflag ${bzero} switchflag ${switch} +4.67637 0.99363 2 0.5 1 rmin0 0 quadraticflag 0 bzeroflag 0 switchflag ${switch} +4.67637 0.99363 2 0.5 1 rmin0 0 quadraticflag 0 bzeroflag 0 switchflag 1 + +# build zero potential to satisfy compute sna/atom + +pair_style zero ${rcutfac} +pair_style zero 4.67637 +pair_coeff * * + +# define atom and grid computes + +compute b all sna/atom ${snap_options} +compute b all sna/atom 4.67637 0.99363 2 0.5 1 rmin0 0 quadraticflag 0 bzeroflag 0 switchflag 1 +compute mygrid all sna/grid grid ${ngridx} ${ngridy} ${ngridz} ${snap_options} +compute mygrid all sna/grid grid 6 ${ngridy} ${ngridz} ${snap_options} +compute mygrid all sna/grid grid 6 4 ${ngridz} ${snap_options} +compute mygrid all sna/grid grid 6 4 2 ${snap_options} +compute mygrid all sna/grid grid 6 4 2 4.67637 0.99363 2 0.5 1 rmin0 0 quadraticflag 0 bzeroflag 0 switchflag 1 +compute mygridlocal all sna/grid/local grid ${ngridx} ${ngridy} ${ngridz} ${snap_options} +compute mygridlocal all sna/grid/local grid 6 ${ngridy} ${ngridz} ${snap_options} +compute mygridlocal all sna/grid/local grid 6 4 ${ngridz} ${snap_options} +compute mygridlocal all sna/grid/local grid 6 4 2 ${snap_options} +compute mygridlocal all sna/grid/local grid 6 4 2 4.67637 0.99363 2 0.5 1 rmin0 0 quadraticflag 0 bzeroflag 0 switchflag 1 + +# define output + +variable B5atom equal c_b[7][5] +variable B5grid equal c_mygrid[13][8] + +# do not compare x,y,z because assignment of ids +# to atoms is not unnique for different processor grids + +variable rmse_global equal "sqrt( (c_mygrid[13][4] - c_b[7][1])^2 + (c_mygrid[13][5] - c_b[7][2])^2 + (c_mygrid[13][6] - c_b[7][3])^2 + (c_mygrid[13][7] - c_b[7][4])^2 + (c_mygrid[13][8] - c_b[7][5])^2 )" + +thermo_style custom step v_B5atom v_B5grid v_rmse_global + +# this is the only way to view the local grid + +dump 1 all local 1000 dump.blocal.tri c_mygridlocal[*] +dump 2 all custom 1000 dump.batom.tri id x y z c_b[*] + +# run + +run 0 +WARNING: No fixes defined, atoms won't move (src/verlet.cpp:55) +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 6.67637 + ghost atom cutoff = 6.67637 + binsize = 3.338185, bins = 6 3 1 + 4 neighbor lists, perpetual/occasional/extra = 1 3 0 + (1) pair zero, perpetual + attributes: half, newton on + pair build: half/bin/newton/tri + stencil: half/bin/3d/tri + bin: standard + (2) compute sna/atom, occasional + attributes: full, newton on + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard + (3) compute sna/grid, occasional + attributes: full, newton on + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard + (4) compute sna/grid/local, occasional + attributes: full, newton on + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 8.435 | 8.435 | 8.435 Mbytes +Step v_B5atom v_B5grid v_rmse_global + 0 1.0427295 1.0427295 7.2262471e-14 +Loop time of 1e-06 on 1 procs for 0 steps with 12 atoms + +100.0% CPU use with 1 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0 | 0 | 0 | 0.0 | 0.00 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0 | 0 | 0 | 0.0 | 0.00 +Output | 0 | 0 | 0 | 0.0 | 0.00 +Modify | 0 | 0 | 0 | 0.0 | 0.00 +Other | | 1e-06 | | |100.00 + +Nlocal: 12.0000 ave 12 max 12 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 604.000 ave 604 max 604 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 384.000 ave 384 max 384 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +FullNghs: 768.000 ave 768 max 768 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 768 +Ave neighs/atom = 64.000000 +Neighbor list builds = 0 +Dangerous builds = 0 + +Total wall time: 0:00:00 diff --git a/examples/snap/log.15Jun22.grid.tri.g++.4 b/examples/snap/log.15Jun22.grid.tri.g++.4 new file mode 100644 index 0000000000..bac7ecaa5a --- /dev/null +++ b/examples/snap/log.15Jun22.grid.tri.g++.4 @@ -0,0 +1,200 @@ +LAMMPS (28 Jul 2021) +# Demonstrate calculation of SNAP bispectrum +# descriptors on a grid for triclinic cell + +# This triclinic cell has 6 times the volume of the single +# unit cell used by in.grid +# and contains 12 atoms. It is a 3x2x1 supercell +# with each unit cell containing 2 atoms and the +# reduced lattice vectors are [1 0 0], [1 1 0], and [1 1 1]. +# The grid is listed in x-fastest order + +# CORRECTNESS: The atom positions coincide with certain +# gridpoints, so c_b[1][1-5] should match c_mygrid[1][4-8] +# and c_b[7][1-5] should match c_mygrid[13][4-8]. +# Local arrays can not be access directly in the script, +# but they are printed out to file dump.blocal.tri + +# Initialize simulation + +variable nrep index 1 +variable a index 3.316 +variable ngrid index 2 + +variable nrepx equal 3*${nrep} +variable nrepx equal 3*1 +variable nrepy equal 2*${nrep} +variable nrepy equal 2*1 +variable nrepz equal 1*${nrep} +variable nrepz equal 1*1 + +variable ngridx equal 3*${ngrid} +variable ngridx equal 3*2 +variable ngridy equal 2*${ngrid} +variable ngridy equal 2*2 +variable ngridz equal 1*${ngrid} +variable ngridz equal 1*2 + +units metal +atom_modify map hash sort 0 0 + +# generate the box and atom positions using a BCC lattice + +variable nx equal ${nrepx} +variable nx equal 3 +variable ny equal ${nrepy} +variable ny equal 2 +variable nz equal ${nrepz} +variable nz equal 1 + +boundary p p p + +lattice custom $a a1 1 0 0 a2 1 1 0 a3 1 1 1 basis 0 0 0 basis 0.0 0.0 0.5 spacing 1 1 1 +lattice custom 3.316 a1 1 0 0 a2 1 1 0 a3 1 1 1 basis 0 0 0 basis 0.0 0.0 0.5 spacing 1 1 1 +Lattice spacing in x,y,z = 3.3160000 3.3160000 3.3160000 + +box tilt large +region box prism 0 ${nx} 0 ${ny} 0 ${nz} ${ny} ${nz} ${nz} +region box prism 0 3 0 ${ny} 0 ${nz} ${ny} ${nz} ${nz} +region box prism 0 3 0 2 0 ${nz} ${ny} ${nz} ${nz} +region box prism 0 3 0 2 0 1 ${ny} ${nz} ${nz} +region box prism 0 3 0 2 0 1 2 ${nz} ${nz} +region box prism 0 3 0 2 0 1 2 1 ${nz} +region box prism 0 3 0 2 0 1 2 1 1 +create_box 1 box +Created triclinic box = (0.0000000 0.0000000 0.0000000) to (9.9480000 6.6320000 3.3160000) with tilt (6.6320000 3.3160000 3.3160000) +WARNING: Triclinic box skew is large (src/domain.cpp:219) + 2 by 2 by 1 MPI processor grid +create_atoms 1 box +Created 12 atoms + using lattice units in triclinic box = (0.0000000 0.0000000 0.0000000) to (9.9480000 6.6320000 3.3160000) with tilt (6.6320000 3.3160000 3.3160000) + create_atoms CPU = 0.001 seconds + +mass 1 180.88 + +# define atom compute and grid compute + +group snapgroup type 1 +12 atoms in group snapgroup +variable twojmax equal 2 +variable rcutfac equal 4.67637 +variable rfac0 equal 0.99363 +variable rmin0 equal 0 +variable wj equal 1 +variable radelem equal 0.5 +variable bzero equal 0 +variable quadratic equal 0 +variable switch equal 1 + +variable snap_options string "${rcutfac} ${rfac0} ${twojmax} ${radelem} ${wj} rmin0 ${rmin0} quadraticflag ${quadratic} bzeroflag ${bzero} switchflag ${switch}" +4.67637 ${rfac0} ${twojmax} ${radelem} ${wj} rmin0 ${rmin0} quadraticflag ${quadratic} bzeroflag ${bzero} switchflag ${switch} +4.67637 0.99363 ${twojmax} ${radelem} ${wj} rmin0 ${rmin0} quadraticflag ${quadratic} bzeroflag ${bzero} switchflag ${switch} +4.67637 0.99363 2 ${radelem} ${wj} rmin0 ${rmin0} quadraticflag ${quadratic} bzeroflag ${bzero} switchflag ${switch} +4.67637 0.99363 2 0.5 ${wj} rmin0 ${rmin0} quadraticflag ${quadratic} bzeroflag ${bzero} switchflag ${switch} +4.67637 0.99363 2 0.5 1 rmin0 ${rmin0} quadraticflag ${quadratic} bzeroflag ${bzero} switchflag ${switch} +4.67637 0.99363 2 0.5 1 rmin0 0 quadraticflag ${quadratic} bzeroflag ${bzero} switchflag ${switch} +4.67637 0.99363 2 0.5 1 rmin0 0 quadraticflag 0 bzeroflag ${bzero} switchflag ${switch} +4.67637 0.99363 2 0.5 1 rmin0 0 quadraticflag 0 bzeroflag 0 switchflag ${switch} +4.67637 0.99363 2 0.5 1 rmin0 0 quadraticflag 0 bzeroflag 0 switchflag 1 + +# build zero potential to satisfy compute sna/atom + +pair_style zero ${rcutfac} +pair_style zero 4.67637 +pair_coeff * * + +# define atom and grid computes + +compute b all sna/atom ${snap_options} +compute b all sna/atom 4.67637 0.99363 2 0.5 1 rmin0 0 quadraticflag 0 bzeroflag 0 switchflag 1 +compute mygrid all sna/grid grid ${ngridx} ${ngridy} ${ngridz} ${snap_options} +compute mygrid all sna/grid grid 6 ${ngridy} ${ngridz} ${snap_options} +compute mygrid all sna/grid grid 6 4 ${ngridz} ${snap_options} +compute mygrid all sna/grid grid 6 4 2 ${snap_options} +compute mygrid all sna/grid grid 6 4 2 4.67637 0.99363 2 0.5 1 rmin0 0 quadraticflag 0 bzeroflag 0 switchflag 1 +compute mygridlocal all sna/grid/local grid ${ngridx} ${ngridy} ${ngridz} ${snap_options} +compute mygridlocal all sna/grid/local grid 6 ${ngridy} ${ngridz} ${snap_options} +compute mygridlocal all sna/grid/local grid 6 4 ${ngridz} ${snap_options} +compute mygridlocal all sna/grid/local grid 6 4 2 ${snap_options} +compute mygridlocal all sna/grid/local grid 6 4 2 4.67637 0.99363 2 0.5 1 rmin0 0 quadraticflag 0 bzeroflag 0 switchflag 1 + +# define output + +variable B5atom equal c_b[7][5] +variable B5grid equal c_mygrid[13][8] + +# do not compare x,y,z because assignment of ids +# to atoms is not unnique for different processor grids + +variable rmse_global equal "sqrt( (c_mygrid[13][4] - c_b[7][1])^2 + (c_mygrid[13][5] - c_b[7][2])^2 + (c_mygrid[13][6] - c_b[7][3])^2 + (c_mygrid[13][7] - c_b[7][4])^2 + (c_mygrid[13][8] - c_b[7][5])^2 )" + +thermo_style custom step v_B5atom v_B5grid v_rmse_global + +# this is the only way to view the local grid + +dump 1 all local 1000 dump.blocal.tri c_mygridlocal[*] +dump 2 all custom 1000 dump.batom.tri id x y z c_b[*] + +# run + +run 0 +WARNING: No fixes defined, atoms won't move (src/verlet.cpp:55) +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 6.67637 + ghost atom cutoff = 6.67637 + binsize = 3.338185, bins = 6 3 1 + 4 neighbor lists, perpetual/occasional/extra = 1 3 0 + (1) pair zero, perpetual + attributes: half, newton on + pair build: half/bin/newton/tri + stencil: half/bin/3d/tri + bin: standard + (2) compute sna/atom, occasional + attributes: full, newton on + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard + (3) compute sna/grid, occasional + attributes: full, newton on + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard + (4) compute sna/grid/local, occasional + attributes: full, newton on + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 8.405 | 8.405 | 8.405 Mbytes +Step v_B5atom v_B5grid v_rmse_global + 0 1.0427295 1.0427295 2.1052124e-14 +Loop time of 1.25e-06 on 4 procs for 0 steps with 12 atoms + +140.0% CPU use with 4 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0 | 0 | 0 | 0.0 | 0.00 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0 | 0 | 0 | 0.0 | 0.00 +Output | 0 | 0 | 0 | 0.0 | 0.00 +Modify | 0 | 0 | 0 | 0.0 | 0.00 +Other | | 1.25e-06 | | |100.00 + +Nlocal: 3.00000 ave 4 max 2 min +Histogram: 2 0 0 0 0 0 0 0 0 2 +Nghost: 459.000 ave 460 max 458 min +Histogram: 2 0 0 0 0 0 0 0 0 2 +Neighs: 96.0000 ave 128 max 64 min +Histogram: 2 0 0 0 0 0 0 0 0 2 +FullNghs: 192.000 ave 256 max 128 min +Histogram: 2 0 0 0 0 0 0 0 0 2 + +Total # of neighbors = 768 +Ave neighs/atom = 64.000000 +Neighbor list builds = 0 +Dangerous builds = 0 + +Total wall time: 0:00:00 From 8004f8bf0ff3a9a4920017e9f6eabe55be48c09f Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Wed, 15 Jun 2022 18:59:48 -0600 Subject: [PATCH 367/585] Removed unneeded member functions and data --- src/compute_grid.cpp | 92 ++++---------------------------------------- src/compute_grid.h | 6 +-- 2 files changed, 9 insertions(+), 89 deletions(-) diff --git a/src/compute_grid.cpp b/src/compute_grid.cpp index 52bd7d6307..91d320bf63 100644 --- a/src/compute_grid.cpp +++ b/src/compute_grid.cpp @@ -28,7 +28,7 @@ using namespace LAMMPS_NS; /* ---------------------------------------------------------------------- */ ComputeGrid::ComputeGrid(LAMMPS *lmp, int narg, char **arg) : - Compute(lmp, narg, arg), grid(nullptr), gridall(nullptr), local_flags(nullptr), gridlocal(nullptr) + Compute(lmp, narg, arg), grid(nullptr), gridall(nullptr), gridlocal(nullptr) { if (narg < 6) error->all(FLERR,"Illegal compute grid command"); @@ -77,8 +77,6 @@ void ComputeGrid::setup() set_grid_global(); set_grid_local(); allocate(); - assign_coords(); - assign_local_flags(); } /* ---------------------------------------------------------------------- @@ -101,91 +99,18 @@ void ComputeGrid::grid2x(int igrid, double *x) } -/* ---------------------------------------------------------------------- - convert global array index to box coords -------------------------------------------------------------------------- */ - -void ComputeGrid::grid2ix(int igrid, int& ix, int& iy, int& iz) -{ - iz = igrid / (nx*ny); - igrid -= iz * (nx*ny); - iy = igrid / nx; - igrid -= iy * nx; - ix = igrid; -} - -// /* ---------------------------------------------------------------------- -// check if grid point is local -// ------------------------------------------------------------------------- */ - -// int ComputeGrid::check_local(int igrid) -// { -// double x[3]; - -// int iz = igrid / (nx*ny); -// igrid -= iz * (nx*ny); -// int iy = igrid / nx; -// igrid -= iy * nx; -// int ix = igrid; - -// x[0] = ix*delx; -// x[1] = iy*dely; -// x[2] = iz*delz; - -// int islocal = -// x[0] >= sublo[0] && x[0] < subhi[0] && -// x[1] >= sublo[1] && x[1] < subhi[1] && -// x[2] >= sublo[2] && x[2] < subhi[2]; - -// return islocal; -// } - -/* ---------------------------------------------------------------------- - check if grid point is local -------------------------------------------------------------------------- */ - -int ComputeGrid::check_local(int igrid) -{ - int ix, iy, iz; - - grid2ix(igrid, ix, iy, iz); - - int islocal = - ix >= nxlo && ix <= nxhi && - iy >= nylo && iy <= nyhi && - iz >= nzlo && iz <= nzhi; - - return islocal; -} - /* ---------------------------------------------------------------------- copy coords to global array ------------------------------------------------------------------------- */ -void ComputeGrid::assign_coords() +void ComputeGrid::assign_coords_all() { double x[3]; for (int igrid = 0; igrid < ngrid; igrid++) { grid2x(igrid,x); - grid[igrid][0] = x[0]; - grid[igrid][1] = x[1]; - grid[igrid][2] = x[2]; - } -} - -/* ---------------------------------------------------------------------- - copy coords to global array -------------------------------------------------------------------------- */ - -void ComputeGrid::assign_local_flags() -{ - for (int igrid = 0; igrid < ngrid; igrid++) { - if (check_local(igrid)) - local_flags[igrid] = 1; - else { - local_flags[igrid] = 0; - memset(grid[igrid],0,size_array_cols * sizeof(double)); - } + gridall[igrid][0] = x[0]; + gridall[igrid][1] = x[1]; + gridall[igrid][2] = x[2]; } } @@ -199,7 +124,6 @@ void ComputeGrid::allocate() memory->create(grid,size_array_rows,size_array_cols,"grid:grid"); memory->create(gridall,size_array_rows,size_array_cols,"grid:gridall"); - memory->create(local_flags,size_array_rows,"grid:local_flags"); if (nxlo <= nxhi && nylo <= nyhi && nzlo <= nzhi) { gridlocal_allocated = 1; memory->create4d_offset(gridlocal,size_array_cols,nzlo,nzhi,nylo,nyhi, @@ -217,7 +141,6 @@ void ComputeGrid::deallocate() { memory->destroy(grid); memory->destroy(gridall); - memory->destroy(local_flags); if (gridlocal_allocated) { gridlocal_allocated = 0; memory->destroy4d_offset(gridlocal,nzlo,nylo,nxlo); @@ -322,8 +245,9 @@ void ComputeGrid::set_grid_local() double ComputeGrid::memory_usage() { double nbytes = size_array_rows*size_array_cols * - sizeof(double); // grid - nbytes += size_array_rows*sizeof(int); // local_flags + sizeof(double); // grid + nbytes += size_array_rows*size_array_cols * + sizeof(double); // gridall nbytes += size_array_cols*ngridlocal*sizeof(double); // gridlocal return nbytes; } diff --git a/src/compute_grid.h b/src/compute_grid.h index 421656febf..ab8e5bbf9e 100644 --- a/src/compute_grid.h +++ b/src/compute_grid.h @@ -46,16 +46,12 @@ class ComputeGrid : public Compute { int nargbase; // number of base class args double cutmax; // largest cutoff distance int size_array_cols_base; // number of columns used for coords, etc. - int *local_flags; // local flag for each grid point int gridlocal_allocated; // shows if gridlocal allocated void allocate(); // create arrays void deallocate(); // free arrays void grid2x(int, double*); // convert grid point to coord - void grid2ix(int, int&, int&, int&); // convert grid point to ix, iy, iz - void assign_coords(); // assign coords for grid - void assign_local_flags(); // set local flag for each grid point - int check_local(int); // check if grid point is local + void assign_coords_all(); // assign coords for global grid void set_grid_global(); // set global grid void set_grid_local(); // set bounds for local grid private: From 9d5f4bf1e9ad7b301c152db0069383d6147f0790 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Wed, 15 Jun 2022 19:02:14 -0600 Subject: [PATCH 368/585] Updated to include switchinnerflag support, anticipating merging in the latest LAMMPS --- src/ML-SNAP/compute_sna_grid.cpp | 36 ++++++++++++++++++++++++-- src/ML-SNAP/compute_sna_grid.h | 3 +++ src/ML-SNAP/compute_sna_grid_local.cpp | 32 ++++++++++++++++++++++- src/ML-SNAP/compute_sna_grid_local.h | 3 +++ 4 files changed, 71 insertions(+), 3 deletions(-) diff --git a/src/ML-SNAP/compute_sna_grid.cpp b/src/ML-SNAP/compute_sna_grid.cpp index 2def0cf6a4..d6ebcda3ef 100644 --- a/src/ML-SNAP/compute_sna_grid.cpp +++ b/src/ML-SNAP/compute_sna_grid.cpp @@ -61,6 +61,7 @@ ComputeSNAGrid::ComputeSNAGrid(LAMMPS *lmp, int narg, char **arg) : chemflag = 0; bnormflag = 0; wselfallflag = 0; + switchinnerflag = 0; nelements = 1; // process required arguments @@ -92,6 +93,11 @@ ComputeSNAGrid::ComputeSNAGrid(LAMMPS *lmp, int narg, char **arg) : } } + // set local input checks + + int sinnerflag = 0; + int dinnerflag = 0; + // process optional args int iarg = nargmin; @@ -140,13 +146,37 @@ ComputeSNAGrid::ComputeSNAGrid(LAMMPS *lmp, int narg, char **arg) : error->all(FLERR,"Illegal compute sna/grid command"); wselfallflag = atoi(arg[iarg+1]); iarg += 2; + } else if (strcmp(arg[iarg],"switchinnerflag") == 0) { + if (iarg+2 > narg) + error->all(FLERR,"Illegal compute snap command"); + switchinnerflag = atoi(arg[iarg+1]); + iarg += 2; + } else if (strcmp(arg[iarg],"sinner") == 0) { + iarg++; + if (iarg+ntypes > narg) + error->all(FLERR,"Illegal compute snap command"); + memory->create(sinnerelem,ntypes+1,"snap:sinnerelem"); + for (int i = 0; i < ntypes; i++) + sinnerelem[i+1] = utils::numeric(FLERR,arg[iarg+i],false,lmp); + sinnerflag = 1; + iarg += ntypes; + } else if (strcmp(arg[iarg],"dinner") == 0) { + iarg++; + if (iarg+ntypes > narg) + error->all(FLERR,"Illegal compute snap command"); + memory->create(dinnerelem,ntypes+1,"snap:dinnerelem"); + for (int i = 0; i < ntypes; i++) + dinnerelem[i+1] = utils::numeric(FLERR,arg[iarg+i],false,lmp); + dinnerflag = 1; + iarg += ntypes; } else error->all(FLERR,"Illegal compute sna/grid command"); } snaptr = new SNA(lmp, rfac0, twojmax, rmin0, switchflag, bzeroflag, - chemflag, bnormflag, wselfallflag, nelements); + chemflag, bnormflag, wselfallflag, + nelements, switchinnerflag); ncoeff = snaptr->ncoeff; nvalues = ncoeff; @@ -287,6 +317,8 @@ void ComputeSNAGrid::compute_array() } } + memset(grid[0],0,ngrid*size_array_cols*sizeof(double)); + for (int iz = nzlo; iz <= nzhi; iz++) for (int iy = nylo; iy <= nyhi; iy++) for (int ix = nxlo; ix <= nxhi; ix++) { @@ -295,7 +327,7 @@ void ComputeSNAGrid::compute_array() grid[igrid][size_array_cols_base + j] = gridlocal[size_array_cols_base + j][iz][iy][ix]; } MPI_Allreduce(&grid[0][0],&gridall[0][0],ngrid*size_array_cols,MPI_DOUBLE,MPI_SUM,world); - + assign_coords_all(); } diff --git a/src/ML-SNAP/compute_sna_grid.h b/src/ML-SNAP/compute_sna_grid.h index d40c87df9b..777b874505 100644 --- a/src/ML-SNAP/compute_sna_grid.h +++ b/src/ML-SNAP/compute_sna_grid.h @@ -42,6 +42,9 @@ class ComputeSNAGrid : public ComputeGrid { double *wjelem; int *map; // map types to [0,nelements) int nelements, chemflag; + int switchinnerflag; + double *sinnerelem; + double *dinnerelem; class SNA *snaptr; double cutmax; int quadraticflag; diff --git a/src/ML-SNAP/compute_sna_grid_local.cpp b/src/ML-SNAP/compute_sna_grid_local.cpp index c1574bfa26..7b26a88975 100644 --- a/src/ML-SNAP/compute_sna_grid_local.cpp +++ b/src/ML-SNAP/compute_sna_grid_local.cpp @@ -61,8 +61,14 @@ ComputeSNAGridLocal::ComputeSNAGridLocal(LAMMPS *lmp, int narg, char **arg) : chemflag = 0; bnormflag = 0; wselfallflag = 0; + switchinnerflag = 0; nelements = 1; + // set local input checks + + int sinnerflag = 0; + int dinnerflag = 0; + // process required arguments memory->create(radelem,ntypes+1,"sna/grid/local:radelem"); // offset by 1 to match up with types @@ -140,13 +146,37 @@ ComputeSNAGridLocal::ComputeSNAGridLocal(LAMMPS *lmp, int narg, char **arg) : error->all(FLERR,"Illegal compute sna/grid/local command"); wselfallflag = atoi(arg[iarg+1]); iarg += 2; + } else if (strcmp(arg[iarg],"switchinnerflag") == 0) { + if (iarg+2 > narg) + error->all(FLERR,"Illegal compute snap command"); + switchinnerflag = atoi(arg[iarg+1]); + iarg += 2; + } else if (strcmp(arg[iarg],"sinner") == 0) { + iarg++; + if (iarg+ntypes > narg) + error->all(FLERR,"Illegal compute snap command"); + memory->create(sinnerelem,ntypes+1,"snap:sinnerelem"); + for (int i = 0; i < ntypes; i++) + sinnerelem[i+1] = utils::numeric(FLERR,arg[iarg+i],false,lmp); + sinnerflag = 1; + iarg += ntypes; + } else if (strcmp(arg[iarg],"dinner") == 0) { + iarg++; + if (iarg+ntypes > narg) + error->all(FLERR,"Illegal compute snap command"); + memory->create(dinnerelem,ntypes+1,"snap:dinnerelem"); + for (int i = 0; i < ntypes; i++) + dinnerelem[i+1] = utils::numeric(FLERR,arg[iarg+i],false,lmp); + dinnerflag = 1; + iarg += ntypes; } else error->all(FLERR,"Illegal compute sna/grid/local command"); } snaptr = new SNA(lmp, rfac0, twojmax, rmin0, switchflag, bzeroflag, - chemflag, bnormflag, wselfallflag, nelements); + chemflag, bnormflag, wselfallflag, + nelements, switchinnerflag); ncoeff = snaptr->ncoeff; nvalues = ncoeff; diff --git a/src/ML-SNAP/compute_sna_grid_local.h b/src/ML-SNAP/compute_sna_grid_local.h index 21e321d123..853d629d87 100644 --- a/src/ML-SNAP/compute_sna_grid_local.h +++ b/src/ML-SNAP/compute_sna_grid_local.h @@ -42,6 +42,9 @@ class ComputeSNAGridLocal : public ComputeGridLocal { double *wjelem; int *map; // map types to [0,nelements) int nelements, chemflag; + int switchinnerflag; + double *sinnerelem; + double *dinnerelem; class SNA *snaptr; double cutmax; int quadraticflag; From cdc0b48a0b5954c557d52c3b53d1c46bbefddfef Mon Sep 17 00:00:00 2001 From: naveen <172697+naveensrinivasan@users.noreply.github.com> Date: Thu, 16 Jun 2022 01:33:01 +0000 Subject: [PATCH 369/585] chore: Included githubactions in the dependabot config This should help with keeping the GitHub actions updated on new releases. This will also help with keeping it secure. Dependabot helps in keeping the supply chain secure https://docs.github.com/en/code-security/dependabot GitHub actions up to date https://docs.github.com/en/code-security/dependabot/working-with-dependabot/keeping-your-actions-up-to-date-with-dependabot https://github.com/ossf/scorecard/blob/main/docs/checks.md#dependency-update-tool Signed-off-by: naveen <172697+naveensrinivasan@users.noreply.github.com> --- .github/dependabot.yml | 6 ++++++ 1 file changed, 6 insertions(+) create mode 100644 .github/dependabot.yml diff --git a/.github/dependabot.yml b/.github/dependabot.yml new file mode 100644 index 0000000000..5ace4600a1 --- /dev/null +++ b/.github/dependabot.yml @@ -0,0 +1,6 @@ +version: 2 +updates: + - package-ecosystem: "github-actions" + directory: "/" + schedule: + interval: "weekly" From 70f836e2753df19a5bcb106717d93bf66dd4cf4e Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Wed, 15 Jun 2022 19:53:37 -0600 Subject: [PATCH 370/585] Updated to latest LAMMPS --- src/ML-SNAP/compute_sna_grid.cpp | 37 +++++++++-------- src/ML-SNAP/compute_sna_grid_local.cpp | 36 +++++++++------- src/ML-SNAP/pair_sna_grid.cpp | 57 +++++++++++++++++++------- src/ML-SNAP/pair_sna_grid.h | 3 ++ 4 files changed, 88 insertions(+), 45 deletions(-) diff --git a/src/ML-SNAP/compute_sna_grid.cpp b/src/ML-SNAP/compute_sna_grid.cpp index d6ebcda3ef..302e81ede2 100644 --- a/src/ML-SNAP/compute_sna_grid.cpp +++ b/src/ML-SNAP/compute_sna_grid.cpp @@ -148,13 +148,13 @@ ComputeSNAGrid::ComputeSNAGrid(LAMMPS *lmp, int narg, char **arg) : iarg += 2; } else if (strcmp(arg[iarg],"switchinnerflag") == 0) { if (iarg+2 > narg) - error->all(FLERR,"Illegal compute snap command"); + error->all(FLERR,"Illegal compute sna/grid command"); switchinnerflag = atoi(arg[iarg+1]); iarg += 2; } else if (strcmp(arg[iarg],"sinner") == 0) { iarg++; if (iarg+ntypes > narg) - error->all(FLERR,"Illegal compute snap command"); + error->all(FLERR,"Illegal compute sna/grid command"); memory->create(sinnerelem,ntypes+1,"snap:sinnerelem"); for (int i = 0; i < ntypes; i++) sinnerelem[i+1] = utils::numeric(FLERR,arg[iarg+i],false,lmp); @@ -163,7 +163,7 @@ ComputeSNAGrid::ComputeSNAGrid(LAMMPS *lmp, int narg, char **arg) : } else if (strcmp(arg[iarg],"dinner") == 0) { iarg++; if (iarg+ntypes > narg) - error->all(FLERR,"Illegal compute snap command"); + error->all(FLERR,"Illegal compute sna/grid command"); memory->create(dinnerelem,ntypes+1,"snap:dinnerelem"); for (int i = 0; i < ntypes; i++) dinnerelem[i+1] = utils::numeric(FLERR,arg[iarg+i],false,lmp); @@ -201,20 +201,20 @@ ComputeSNAGrid::~ComputeSNAGrid() void ComputeSNAGrid::init() { - if (force->pair == nullptr) - error->all(FLERR,"Compute sna/grid requires a pair style be defined"); + // if (force->pair == nullptr) + // error->all(FLERR,"Compute sna/grid requires a pair style be defined"); - if (cutmax > force->pair->cutforce) - error->all(FLERR,"Compute sna/grid cutoff is longer than pairwise cutoff"); + // if (cutmax > force->pair->cutforce) + // error->all(FLERR,"Compute sna/grid cutoff is longer than pairwise cutoff"); - // need an occasional full neighbor list + // // need an occasional full neighbor list - int irequest = neighbor->request(this,instance_me); - neighbor->requests[irequest]->pair = 0; - neighbor->requests[irequest]->compute = 1; - neighbor->requests[irequest]->half = 0; - neighbor->requests[irequest]->full = 1; - neighbor->requests[irequest]->occasional = 1; + // int irequest = neighbor->request(this,instance_me); + // neighbor->requests[irequest]->pair = 0; + // neighbor->requests[irequest]->compute = 1; + // neighbor->requests[irequest]->half = 0; + // neighbor->requests[irequest]->full = 1; + // neighbor->requests[irequest]->occasional = 1; int count = 0; for (int i = 0; i < modify->ncompute; i++) @@ -282,7 +282,8 @@ void ComputeSNAGrid::compute_array() int jtype = type[j]; int jelem = 0; if (chemflag) - jelem = map[jtype]; + jelem = map[jtype]; + if (rsq < cutsq[jtype][jtype] && rsq > 1e-20) { snaptr->rij[ninside][0] = delx; snaptr->rij[ninside][1] = dely; @@ -290,7 +291,11 @@ void ComputeSNAGrid::compute_array() snaptr->inside[ninside] = j; snaptr->wj[ninside] = wjelem[jtype]; snaptr->rcutij[ninside] = 2.0*radelem[jtype]*rcutfac; - snaptr->element[ninside] = jelem; // element index for multi-element snap + if (switchinnerflag) { + snaptr->sinnerij[ninside] = sinnerelem[jelem]; + snaptr->dinnerij[ninside] = dinnerelem[jelem]; + } + if (chemflag) snaptr->element[ninside] = jelem; ninside++; } } diff --git a/src/ML-SNAP/compute_sna_grid_local.cpp b/src/ML-SNAP/compute_sna_grid_local.cpp index 7b26a88975..67ac316834 100644 --- a/src/ML-SNAP/compute_sna_grid_local.cpp +++ b/src/ML-SNAP/compute_sna_grid_local.cpp @@ -148,13 +148,13 @@ ComputeSNAGridLocal::ComputeSNAGridLocal(LAMMPS *lmp, int narg, char **arg) : iarg += 2; } else if (strcmp(arg[iarg],"switchinnerflag") == 0) { if (iarg+2 > narg) - error->all(FLERR,"Illegal compute snap command"); + error->all(FLERR,"Illegal compute sna/grid/local command"); switchinnerflag = atoi(arg[iarg+1]); iarg += 2; } else if (strcmp(arg[iarg],"sinner") == 0) { iarg++; if (iarg+ntypes > narg) - error->all(FLERR,"Illegal compute snap command"); + error->all(FLERR,"Illegal compute sna/grid/local command"); memory->create(sinnerelem,ntypes+1,"snap:sinnerelem"); for (int i = 0; i < ntypes; i++) sinnerelem[i+1] = utils::numeric(FLERR,arg[iarg+i],false,lmp); @@ -163,7 +163,7 @@ ComputeSNAGridLocal::ComputeSNAGridLocal(LAMMPS *lmp, int narg, char **arg) : } else if (strcmp(arg[iarg],"dinner") == 0) { iarg++; if (iarg+ntypes > narg) - error->all(FLERR,"Illegal compute snap command"); + error->all(FLERR,"Illegal compute sna/grid/local command"); memory->create(dinnerelem,ntypes+1,"snap:dinnerelem"); for (int i = 0; i < ntypes; i++) dinnerelem[i+1] = utils::numeric(FLERR,arg[iarg+i],false,lmp); @@ -200,20 +200,20 @@ ComputeSNAGridLocal::~ComputeSNAGridLocal() void ComputeSNAGridLocal::init() { - if (force->pair == nullptr) - error->all(FLERR,"Compute sna/grid/local requires a pair style be defined"); + // if (force->pair == nullptr) + // error->all(FLERR,"Compute sna/grid/local requires a pair style be defined"); - if (cutmax > force->pair->cutforce) - error->all(FLERR,"Compute sna/grid/local cutoff is longer than pairwise cutoff"); + // if (cutmax > force->pair->cutforce) + // error->all(FLERR,"Compute sna/grid/local cutoff is longer than pairwise cutoff"); - // need an occasional full neighbor list + // // need an occasional full neighbor list - int irequest = neighbor->request(this,instance_me); - neighbor->requests[irequest]->pair = 0; - neighbor->requests[irequest]->compute = 1; - neighbor->requests[irequest]->half = 0; - neighbor->requests[irequest]->full = 1; - neighbor->requests[irequest]->occasional = 1; + // int irequest = neighbor->request(this,instance_me); + // neighbor->requests[irequest]->pair = 0; + // neighbor->requests[irequest]->compute = 1; + // neighbor->requests[irequest]->half = 0; + // neighbor->requests[irequest]->full = 1; + // neighbor->requests[irequest]->occasional = 1; int count = 0; for (int i = 0; i < modify->ncompute; i++) @@ -234,6 +234,7 @@ void ComputeSNAGridLocal::init_list(int /*id*/, NeighList *ptr) void ComputeSNAGridLocal::compute_local() { + printf("Entering compute_local()\n"); invoked_array = update->ntimestep; // compute sna for each gridpoint @@ -290,7 +291,11 @@ void ComputeSNAGridLocal::compute_local() snaptr->inside[ninside] = j; snaptr->wj[ninside] = wjelem[jtype]; snaptr->rcutij[ninside] = 2.0*radelem[jtype]*rcutfac; - snaptr->element[ninside] = jelem; // element index for multi-element snap + if (switchinnerflag) { + snaptr->sinnerij[ninside] = sinnerelem[jelem]; + snaptr->dinnerij[ninside] = dinnerelem[jelem]; + } + if (chemflag) snaptr->element[ninside] = jelem; // element index for multi-element snap ninside++; } } @@ -323,6 +328,7 @@ void ComputeSNAGridLocal::compute_local() // copy 4d array to 2d array copy_gridlocal_to_local_array(); + printf("Exiting compute_local()\n"); } diff --git a/src/ML-SNAP/pair_sna_grid.cpp b/src/ML-SNAP/pair_sna_grid.cpp index 43a07b48e4..effed79ebf 100644 --- a/src/ML-SNAP/pair_sna_grid.cpp +++ b/src/ML-SNAP/pair_sna_grid.cpp @@ -59,15 +59,16 @@ void PairSNAGrid::init_style() if (force->newton_pair == 0) error->all(FLERR,"Pair style sna/grid requires newton pair on"); - // need a full neighbor list + // // need a full neighbor list - int irequest = neighbor->request(this,instance_me); - neighbor->requests[irequest]->half = 0; - neighbor->requests[irequest]->full = 1; + // int irequest = neighbor->request(this,instance_me); + // neighbor->requests[irequest]->half = 0; + // neighbor->requests[irequest]->full = 1; snaptr = new SNA(lmp, rfac0, twojmax, rmin0, switchflag, bzeroflag, - chemflag, bnormflag, wselfallflag, nelements); + chemflag, bnormflag, wselfallflag, + nelements, switchinnerflag); ncoeff = snaptr->ncoeff; ndesc = ndesc_base + ncoeff; snaptr->init(); @@ -213,8 +214,8 @@ void PairSNAGrid::compute(int eflag, int vflag) const double rsq = delx*delx + dely*dely + delz*delz; int jtype = type[j]; int jelem = 0; - if (chemflag) - jelem = map[jtype]; + jelem = map[jtype]; + if (rsq < cutsq[jtype][jtype] && rsq > 1e-20) { snaptr->rij[ninside][0] = delx; snaptr->rij[ninside][1] = dely; @@ -222,7 +223,11 @@ void PairSNAGrid::compute(int eflag, int vflag) snaptr->inside[ninside] = j; snaptr->wj[ninside] = wjelem[jtype]; snaptr->rcutij[ninside] = 2.0*radelem[jtype]*rcutfac; - snaptr->element[ninside] = jelem; // element index for multi-element snap + if (switchinnerflag) { + snaptr->sinnerij[ninside] = 0.5*(sinnerelem[ielem]+sinnerelem[jelem]); + snaptr->dinnerij[ninside] = 0.5*(dinnerelem[ielem]+dinnerelem[jelem]); + } + if (chemflag) snaptr->element[ninside] = jelem; ninside++; } } @@ -243,12 +248,7 @@ void PairSNAGrid::compute(int eflag, int vflag) for (int jj = 0; jj < ninside; jj++) { int j = snaptr->inside[jj]; - if (chemflag) - snaptr->compute_duidrj(snaptr->rij[jj], snaptr->wj[jj], - snaptr->rcutij[jj],jj, snaptr->element[jj]); - else - snaptr->compute_duidrj(snaptr->rij[jj], snaptr->wj[jj], - snaptr->rcutij[jj],jj, 0); + snaptr->compute_duidrj(jj); snaptr->compute_deidrj(fij); @@ -326,6 +326,7 @@ void PairSNAGrid::settings(int narg, char ** arg) chemflag = 0; bnormflag = 0; wselfallflag = 0; + switchinnerflag = 0; nelements = 1; // process required arguments @@ -357,6 +358,11 @@ void PairSNAGrid::settings(int narg, char ** arg) } } + // set local input checks + + int sinnerflag = 0; + int dinnerflag = 0; + // process optional args int iarg = nargmin; @@ -405,6 +411,29 @@ void PairSNAGrid::settings(int narg, char ** arg) error->all(FLERR,"Illegal pair sna/grid command"); wselfallflag = atoi(arg[iarg+1]); iarg += 2; + } else if (strcmp(arg[iarg],"switchinnerflag") == 0) { + if (iarg+2 > narg) + error->all(FLERR,"Illegal pair sna/grid command"); + switchinnerflag = atoi(arg[iarg+1]); + iarg += 2; + } else if (strcmp(arg[iarg],"sinner") == 0) { + iarg++; + if (iarg+ntypes > narg) + error->all(FLERR,"Illegal pair sna/grid command"); + memory->create(sinnerelem,ntypes+1,"snap:sinnerelem"); + for (int i = 0; i < ntypes; i++) + sinnerelem[i+1] = utils::numeric(FLERR,arg[iarg+i],false,lmp); + sinnerflag = 1; + iarg += ntypes; + } else if (strcmp(arg[iarg],"dinner") == 0) { + iarg++; + if (iarg+ntypes > narg) + error->all(FLERR,"Illegal pair sna/grid command"); + memory->create(dinnerelem,ntypes+1,"snap:dinnerelem"); + for (int i = 0; i < ntypes; i++) + dinnerelem[i+1] = utils::numeric(FLERR,arg[iarg+i],false,lmp); + dinnerflag = 1; + iarg += ntypes; } else error->all(FLERR,"Illegal pair sna/grid command"); } diff --git a/src/ML-SNAP/pair_sna_grid.h b/src/ML-SNAP/pair_sna_grid.h index 9ae0eece79..653bb9d1c1 100644 --- a/src/ML-SNAP/pair_sna_grid.h +++ b/src/ML-SNAP/pair_sna_grid.h @@ -45,6 +45,9 @@ class PairSNAGrid : public PairGrid { int quadraticflag; int twojmax, switchflag, bzeroflag, bnormflag; int chemflag, wselfallflag; + int switchinnerflag; + double *sinnerelem; + double *dinnerelem; double rfac0, rmin0; }; From 483e3cf04996125511bcd2b5d7aa0d295fdb072e Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Wed, 15 Jun 2022 20:28:22 -0600 Subject: [PATCH 371/585] Eliminated global storage for grid/local --- src/ML-SNAP/compute_sna_grid_local.cpp | 33 +++----------- src/ML-SNAP/pair_sna_grid.cpp | 6 --- src/compute_grid_local.cpp | 63 +++++--------------------- src/compute_grid_local.h | 1 - 4 files changed, 18 insertions(+), 85 deletions(-) diff --git a/src/ML-SNAP/compute_sna_grid_local.cpp b/src/ML-SNAP/compute_sna_grid_local.cpp index 67ac316834..e45a334d67 100644 --- a/src/ML-SNAP/compute_sna_grid_local.cpp +++ b/src/ML-SNAP/compute_sna_grid_local.cpp @@ -200,21 +200,6 @@ ComputeSNAGridLocal::~ComputeSNAGridLocal() void ComputeSNAGridLocal::init() { - // if (force->pair == nullptr) - // error->all(FLERR,"Compute sna/grid/local requires a pair style be defined"); - - // if (cutmax > force->pair->cutforce) - // error->all(FLERR,"Compute sna/grid/local cutoff is longer than pairwise cutoff"); - - // // need an occasional full neighbor list - - // int irequest = neighbor->request(this,instance_me); - // neighbor->requests[irequest]->pair = 0; - // neighbor->requests[irequest]->compute = 1; - // neighbor->requests[irequest]->half = 0; - // neighbor->requests[irequest]->full = 1; - // neighbor->requests[irequest]->occasional = 1; - int count = 0; for (int i = 0; i < modify->ncompute; i++) if (strcmp(modify->compute[i]->style,"sna/grid/local") == 0) count++; @@ -234,7 +219,6 @@ void ComputeSNAGridLocal::init_list(int /*id*/, NeighList *ptr) void ComputeSNAGridLocal::compute_local() { - printf("Entering compute_local()\n"); invoked_array = update->ntimestep; // compute sna for each gridpoint @@ -248,6 +232,7 @@ void ComputeSNAGridLocal::compute_local() snaptr->grow_rij(ntotal); + int igrid = 0; for (int iz = nzlo; iz <= nzhi; iz++) for (int iy = nylo; iy <= nyhi; iy++) for (int ix = nxlo; ix <= nxhi; ix++) { @@ -307,8 +292,7 @@ void ComputeSNAGridLocal::compute_local() // linear contributions for (int icoeff = 0; icoeff < ncoeff; icoeff++) - gridlocal[size_local_cols_base+icoeff][iz][iy][ix] = - snaptr->blist[icoeff]; + alocal[igrid][size_local_cols_base+icoeff] = snaptr->blist[icoeff]; // quadratic contributions @@ -316,19 +300,14 @@ void ComputeSNAGridLocal::compute_local() int ncount = ncoeff; for (int icoeff = 0; icoeff < ncoeff; icoeff++) { double bveci = snaptr->blist[icoeff]; - gridlocal[size_local_cols_base+ncount++][iz][iy][ix] = - 0.5*bveci*bveci; + alocal[igrid][size_local_cols_base+ncount++] = 0.5*bveci*bveci; for (int jcoeff = icoeff+1; jcoeff < ncoeff; jcoeff++) - gridlocal[size_local_cols_base+ncount++][iz][iy][ix] = + alocal[igrid][size_local_cols_base+ncount++] = bveci*snaptr->blist[jcoeff]; } } + igrid++; } - - // copy 4d array to 2d array - - copy_gridlocal_to_local_array(); - printf("Exiting compute_local()\n"); } @@ -340,7 +319,7 @@ double ComputeSNAGridLocal::memory_usage() { double nbytes = snaptr->memory_usage(); // SNA object int n = atom->ntypes+1; - nbytes += (double)n*sizeof(int); // map + nbytes += (double)n*sizeof(int); // map return nbytes; } diff --git a/src/ML-SNAP/pair_sna_grid.cpp b/src/ML-SNAP/pair_sna_grid.cpp index effed79ebf..ffb4dfa033 100644 --- a/src/ML-SNAP/pair_sna_grid.cpp +++ b/src/ML-SNAP/pair_sna_grid.cpp @@ -59,12 +59,6 @@ void PairSNAGrid::init_style() if (force->newton_pair == 0) error->all(FLERR,"Pair style sna/grid requires newton pair on"); - // // need a full neighbor list - - // int irequest = neighbor->request(this,instance_me); - // neighbor->requests[irequest]->half = 0; - // neighbor->requests[irequest]->full = 1; - snaptr = new SNA(lmp, rfac0, twojmax, rmin0, switchflag, bzeroflag, chemflag, bnormflag, wselfallflag, diff --git a/src/compute_grid_local.cpp b/src/compute_grid_local.cpp index 504555a718..4169d23e54 100644 --- a/src/compute_grid_local.cpp +++ b/src/compute_grid_local.cpp @@ -117,8 +117,6 @@ void ComputeGridLocal::allocate() { if (nxlo <= nxhi && nylo <= nyhi && nzlo <= nzhi) { gridlocal_allocated = 1; - memory->create4d_offset(gridlocal,size_local_cols,nzlo,nzhi,nylo,nyhi, - nxlo,nxhi,"grid:gridlocal"); memory->create(alocal, size_local_rows, size_local_cols, "compute/grid/local:alocal"); array_local = alocal; } @@ -132,7 +130,6 @@ void ComputeGridLocal::deallocate() { if (gridlocal_allocated) { gridlocal_allocated = 0; - memory->destroy4d_offset(gridlocal,nzlo,nylo,nxlo); memory->destroy(alocal); } array_local = nullptr; @@ -208,19 +205,6 @@ void ComputeGridLocal::set_grid_local() zfrachi = comm->mysplit[2][1]; } - // // not fully clear why this works - // // without, sometimes get uneven assignments - // // in case where ngridz is multiple of nprocz - - // double MYEPS = 1.0e-10; - - // xfraclo += MYEPS; - // xfrachi += MYEPS; - // yfraclo += MYEPS; - // yfrachi += MYEPS; - // zfraclo += MYEPS; - // zfrachi += MYEPS; - nxlo = static_cast (xfraclo * nx); if (1.0*nxlo != xfraclo*nx) nxlo++; nxhi = static_cast (xfrachi * nx); @@ -255,27 +239,20 @@ void ComputeGridLocal::assign_coords() alocal[igrid][2] = iz; double xgrid[3]; - // For triclinic: create gridpoint in lamda coordinates and transform after check. - // For orthorombic: create gridpoint in box coordinates. + // for triclinic: create gridpoint in lamda coordinates and transform after check. + // for orthorombic: create gridpoint in box coordinates. - if (triclinic) - { - grid2lamda(ix, iy, iz, xgrid); - } - else - { - grid2x(ix, iy, iz, xgrid); - } + if (triclinic) + grid2lamda(ix, iy, iz, xgrid); + else + grid2x(ix, iy, iz, xgrid); - // Ensure gridpoint is not strictly outside subdomain. - // There have been some problem with a gridpoint being something like 2e-17 outside of the subdomain, - // thus the EPISLON check. - if ((sublo[0]-xgrid[0]) > EPSILON || (xgrid[0]-subhi[0]) > EPSILON || - (sublo[1]-xgrid[1]) > EPSILON || (xgrid[1]-subhi[1]) > EPSILON || - (sublo[2]-xgrid[2]) > EPSILON || (xgrid[2]-subhi[2]) > EPSILON) - { - error->one(FLERR,"Invalid gridpoint position in compute grid/local"); - } + // ensure gridpoint is not strictly outside subdomain + + if ((sublo[0]-xgrid[0]) > EPSILON || (xgrid[0]-subhi[0]) > EPSILON || + (sublo[1]-xgrid[1]) > EPSILON || (xgrid[1]-subhi[1]) > EPSILON || + (sublo[2]-xgrid[2]) > EPSILON || (xgrid[2]-subhi[2]) > EPSILON) + error->one(FLERR,"Invalid gridpoint position in compute grid/local"); // convert lamda to x, y, z, after sudomain check @@ -288,22 +265,6 @@ void ComputeGridLocal::assign_coords() } } -/* ---------------------------------------------------------------------- - copy the 4d gridlocal array values to the 2d local array -------------------------------------------------------------------------- */ - -void ComputeGridLocal::copy_gridlocal_to_local_array() -{ - int igrid = 0; - for (int iz = nzlo; iz <= nzhi; iz++) - for (int iy = nylo; iy <= nyhi; iy++) - for (int ix = nxlo; ix <= nxhi; ix++) { - for (int icol = size_local_cols_base; icol < size_local_cols; icol++) - alocal[igrid][icol] = gridlocal[icol][iz][iy][ix]; - igrid++; - } -} - /* ---------------------------------------------------------------------- memory usage of local data ------------------------------------------------------------------------- */ diff --git a/src/compute_grid_local.h b/src/compute_grid_local.h index 79a5ea765d..0e6e37cd35 100644 --- a/src/compute_grid_local.h +++ b/src/compute_grid_local.h @@ -53,7 +53,6 @@ class ComputeGridLocal : public Compute { void set_grid_global(); // set global grid void set_grid_local(); // set bounds for local grid void assign_coords(); // assign coords for grid - void copy_gridlocal_to_local_array();// copy 4d gridlocal array to 2d local array private: }; From e30f86c2ff31775d8dd282e157f7c056c5693505 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Thu, 16 Jun 2022 08:22:51 -0600 Subject: [PATCH 372/585] Removed a few more unnecessary member data --- src/compute_grid_local.cpp | 7 +++---- src/compute_grid_local.h | 2 -- 2 files changed, 3 insertions(+), 6 deletions(-) diff --git a/src/compute_grid_local.cpp b/src/compute_grid_local.cpp index 4169d23e54..bcc56c3abd 100644 --- a/src/compute_grid_local.cpp +++ b/src/compute_grid_local.cpp @@ -32,7 +32,7 @@ using namespace LAMMPS_NS; /* ---------------------------------------------------------------------- */ ComputeGridLocal::ComputeGridLocal(LAMMPS *lmp, int narg, char **arg) : - Compute(lmp, narg, arg), gridlocal(nullptr), alocal(nullptr) + Compute(lmp, narg, arg), alocal(nullptr) { if (narg < 6) error->all(FLERR,"Illegal compute grid/local command"); @@ -220,8 +220,7 @@ void ComputeGridLocal::set_grid_local() nzhi = static_cast (zfrachi * nz); if (1.0*nzhi == zfrachi*nz) nzhi--; - ngridlocal = (nxhi - nxlo + 1) * (nyhi - nylo + 1) * (nzhi - nzlo + 1); - size_local_rows = ngridlocal; + size_local_rows = (nxhi - nxlo + 1) * (nyhi - nylo + 1) * (nzhi - nzlo + 1); } /* ---------------------------------------------------------------------- @@ -271,6 +270,6 @@ void ComputeGridLocal::assign_coords() double ComputeGridLocal::memory_usage() { - int nbytes = size_local_cols*ngridlocal*sizeof(double); // gridlocal + int nbytes = size_local_rows * size_local_cols * sizeof(double); // gridlocal return nbytes; } diff --git a/src/compute_grid_local.h b/src/compute_grid_local.h index 0e6e37cd35..15ea8ca47f 100644 --- a/src/compute_grid_local.h +++ b/src/compute_grid_local.h @@ -32,9 +32,7 @@ class ComputeGridLocal : public Compute { protected: int nx, ny, nz; // global grid dimensions int nxlo, nxhi, nylo, nyhi, nzlo, nzhi; // local grid bounds, inclusive - int ngridlocal; // number of local grid points int nvalues; // number of values per grid point - double ****gridlocal; // local grid, redundant w.r.t. alocal double **alocal; // pointer to Compute::array_local int triclinic; // triclinic flag double *boxlo, *prd; // box info (units real/ortho or reduced/tri) From 535a5211fc60dcd9571596ac1403c8f1f91fa6d9 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Thu, 16 Jun 2022 10:33:54 -0600 Subject: [PATCH 373/585] More cleanup --- src/ML-SNAP/compute_sna_grid.cpp | 23 ++++++++--------------- src/ML-SNAP/compute_sna_grid_local.cpp | 6 ++++++ 2 files changed, 14 insertions(+), 15 deletions(-) diff --git a/src/ML-SNAP/compute_sna_grid.cpp b/src/ML-SNAP/compute_sna_grid.cpp index 302e81ede2..e96b54e7ed 100644 --- a/src/ML-SNAP/compute_sna_grid.cpp +++ b/src/ML-SNAP/compute_sna_grid.cpp @@ -173,6 +173,12 @@ ComputeSNAGrid::ComputeSNAGrid(LAMMPS *lmp, int narg, char **arg) : } + if (switchinnerflag && !(sinnerflag && dinnerflag)) + error->all(FLERR,"Illegal compute sna/grid command: switchinnerflag = 1, missing sinner/dinner keyword"); + + if (!switchinnerflag && (sinnerflag || dinnerflag)) + error->all(FLERR,"Illegal compute sna/grid command: switchinnerflag = 0, unexpected sinner/dinner keyword"); + snaptr = new SNA(lmp, rfac0, twojmax, rmin0, switchflag, bzeroflag, chemflag, bnormflag, wselfallflag, @@ -201,21 +207,6 @@ ComputeSNAGrid::~ComputeSNAGrid() void ComputeSNAGrid::init() { - // if (force->pair == nullptr) - // error->all(FLERR,"Compute sna/grid requires a pair style be defined"); - - // if (cutmax > force->pair->cutforce) - // error->all(FLERR,"Compute sna/grid cutoff is longer than pairwise cutoff"); - - // // need an occasional full neighbor list - - // int irequest = neighbor->request(this,instance_me); - // neighbor->requests[irequest]->pair = 0; - // neighbor->requests[irequest]->compute = 1; - // neighbor->requests[irequest]->half = 0; - // neighbor->requests[irequest]->full = 1; - // neighbor->requests[irequest]->occasional = 1; - int count = 0; for (int i = 0; i < modify->ncompute; i++) if (strcmp(modify->compute[i]->style,"sna/grid") == 0) count++; @@ -284,6 +275,8 @@ void ComputeSNAGrid::compute_array() if (chemflag) jelem = map[jtype]; + // printf("jtype = %d cutsq[jtype][jtype] = %g\n", + // jtype, cutsq[jtype][jtype]); if (rsq < cutsq[jtype][jtype] && rsq > 1e-20) { snaptr->rij[ninside][0] = delx; snaptr->rij[ninside][1] = dely; diff --git a/src/ML-SNAP/compute_sna_grid_local.cpp b/src/ML-SNAP/compute_sna_grid_local.cpp index e45a334d67..1dacc28617 100644 --- a/src/ML-SNAP/compute_sna_grid_local.cpp +++ b/src/ML-SNAP/compute_sna_grid_local.cpp @@ -173,6 +173,12 @@ ComputeSNAGridLocal::ComputeSNAGridLocal(LAMMPS *lmp, int narg, char **arg) : } + if (switchinnerflag && !(sinnerflag && dinnerflag)) + error->all(FLERR,"Illegal compute sna/grid/local command: switchinnerflag = 1, missing sinner/dinner keyword"); + + if (!switchinnerflag && (sinnerflag || dinnerflag)) + error->all(FLERR,"Illegal compute sna/grid/local command: switchinnerflag = 0, unexpected sinner/dinner keyword"); + snaptr = new SNA(lmp, rfac0, twojmax, rmin0, switchflag, bzeroflag, chemflag, bnormflag, wselfallflag, From 0a5d921f3f08167e3c7c5476cc46379dde719464 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 16 Jun 2022 15:37:55 -0400 Subject: [PATCH 374/585] update affiliation in source code as well --- src/DPD-MESO/fix_mvv_dpd.cpp | 4 ++-- src/DPD-MESO/fix_mvv_edpd.cpp | 4 ++-- src/DPD-MESO/fix_mvv_tdpd.cpp | 4 ++-- src/DPD-MESO/pair_edpd.cpp | 4 ++-- src/DPD-MESO/pair_mdpd.cpp | 4 ++-- src/DPD-MESO/pair_mdpd_rhosum.cpp | 2 +- src/DPD-MESO/pair_tdpd.cpp | 4 ++-- 7 files changed, 13 insertions(+), 13 deletions(-) diff --git a/src/DPD-MESO/fix_mvv_dpd.cpp b/src/DPD-MESO/fix_mvv_dpd.cpp index 73290535b1..d96031c9f9 100644 --- a/src/DPD-MESO/fix_mvv_dpd.cpp +++ b/src/DPD-MESO/fix_mvv_dpd.cpp @@ -17,8 +17,8 @@ modified velocity-Verlet (MVV) algorithm. Setting verlet = 0.5 recovers the standard velocity-Verlet algorithm. - Contributing author: Zhen Li (Brown University) - Email: zhen_li@brown.edu + Contributing author: Zhen Li (Clemson University) + Email: zli7@clemson.edu ------------------------------------------------------------------------- */ #include "fix_mvv_dpd.h" diff --git a/src/DPD-MESO/fix_mvv_edpd.cpp b/src/DPD-MESO/fix_mvv_edpd.cpp index 856647d792..9b31bc4c5d 100644 --- a/src/DPD-MESO/fix_mvv_edpd.cpp +++ b/src/DPD-MESO/fix_mvv_edpd.cpp @@ -17,8 +17,8 @@ v and edpd_T) using the modified velocity-Verlet (MVV) algorithm. Setting verlet = 0.5 recovers the standard velocity-Verlet algorithm. - Contributing author: Zhen Li (Brown University) - Email: zhen_li@brown.edu + Contributing author: Zhen Li (Clemson University) + Email: zli7@clemson.edu Please cite the related publication: Z. Li, Y.-H. Tang, H. Lei, B. Caswell and G.E. Karniadakis. "Energy- diff --git a/src/DPD-MESO/fix_mvv_tdpd.cpp b/src/DPD-MESO/fix_mvv_tdpd.cpp index 00c6e29968..1a0dc5d520 100644 --- a/src/DPD-MESO/fix_mvv_tdpd.cpp +++ b/src/DPD-MESO/fix_mvv_tdpd.cpp @@ -17,8 +17,8 @@ v and cc) using the modified velocity-Verlet (MVV) algorithm. Setting verlet = 0.5 recovers the standard velocity-Verlet algorithm. - Contributing author: Zhen Li (Brown University) - Email: zhen_li@brown.edu + Contributing author: Zhen Li (Clemson University) + Email: zli7@clemson.edu Please cite the related publication: Z. Li, A. Yazdani, A. Tartakovsky and G.E. Karniadakis. "Transport diff --git a/src/DPD-MESO/pair_edpd.cpp b/src/DPD-MESO/pair_edpd.cpp index ddbbd05085..b05f588b7c 100644 --- a/src/DPD-MESO/pair_edpd.cpp +++ b/src/DPD-MESO/pair_edpd.cpp @@ -13,8 +13,8 @@ ------------------------------------------------------------------------- */ /* ---------------------------------------------------------------------- - Contributing author: Zhen Li (Brown University) - Email: zhen_li@brown.edu + Contributing author: Zhen Li (Clemson University) + Email: zli7@clemson.edu ------------------------------------------------------------------------- */ #include "pair_edpd.h" diff --git a/src/DPD-MESO/pair_mdpd.cpp b/src/DPD-MESO/pair_mdpd.cpp index 053d322f00..ec0a57be15 100644 --- a/src/DPD-MESO/pair_mdpd.cpp +++ b/src/DPD-MESO/pair_mdpd.cpp @@ -13,8 +13,8 @@ ------------------------------------------------------------------------- */ /* ---------------------------------------------------------------------- - Contributing author: Zhen Li (Brown University) - Email: zhen_li@brown.edu + Contributing author: Zhen Li (Clemson University) + Email: zli7@clemson.edu ------------------------------------------------------------------------- */ #include "pair_mdpd.h" diff --git a/src/DPD-MESO/pair_mdpd_rhosum.cpp b/src/DPD-MESO/pair_mdpd_rhosum.cpp index b44ca94c4e..773248a212 100644 --- a/src/DPD-MESO/pair_mdpd_rhosum.cpp +++ b/src/DPD-MESO/pair_mdpd_rhosum.cpp @@ -17,7 +17,7 @@ before the force calculation. The code uses 3D Lucy kernel, it can be modified for other kernels. - Contributing author: Zhen Li (Brown University) + Contributing author: Zhen Li (Clemson University) ------------------------------------------------------------------------- */ #include "pair_mdpd_rhosum.h" diff --git a/src/DPD-MESO/pair_tdpd.cpp b/src/DPD-MESO/pair_tdpd.cpp index 76f4b59108..39d9a151d9 100644 --- a/src/DPD-MESO/pair_tdpd.cpp +++ b/src/DPD-MESO/pair_tdpd.cpp @@ -13,8 +13,8 @@ ------------------------------------------------------------------------- */ /* ---------------------------------------------------------------------- - Contributing author: Zhen Li (Brown University) - Email: zhen_li@brown.edu + Contributing author: Zhen Li (Clemson University) + Email: zli7@clemson.edu ------------------------------------------------------------------------- */ #include "pair_tdpd.h" From ba4cbf7055b6e8e98ed1fbd06ff7c3a0998bccf8 Mon Sep 17 00:00:00 2001 From: "dependabot[bot]" <49699333+dependabot[bot]@users.noreply.github.com> Date: Thu, 16 Jun 2022 19:41:20 +0000 Subject: [PATCH 375/585] Bump actions/setup-python from 2 to 4 Bumps [actions/setup-python](https://github.com/actions/setup-python) from 2 to 4. - [Release notes](https://github.com/actions/setup-python/releases) - [Commits](https://github.com/actions/setup-python/compare/v2...v4) --- updated-dependencies: - dependency-name: actions/setup-python dependency-type: direct:production update-type: version-update:semver-major ... Signed-off-by: dependabot[bot] --- .github/workflows/codeql-analysis.yml | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/.github/workflows/codeql-analysis.yml b/.github/workflows/codeql-analysis.yml index 07b64296a7..07f7564727 100644 --- a/.github/workflows/codeql-analysis.yml +++ b/.github/workflows/codeql-analysis.yml @@ -30,7 +30,7 @@ jobs: fetch-depth: 2 - name: Setup Python - uses: actions/setup-python@v2 + uses: actions/setup-python@v4 with: python-version: '3.x' From 2fc0a44ab20b1f64ed0539b37ecef76d2a9bb648 Mon Sep 17 00:00:00 2001 From: "dependabot[bot]" <49699333+dependabot[bot]@users.noreply.github.com> Date: Thu, 16 Jun 2022 19:41:23 +0000 Subject: [PATCH 376/585] Bump actions/cache from 2 to 3 Bumps [actions/cache](https://github.com/actions/cache) from 2 to 3. - [Release notes](https://github.com/actions/cache/releases) - [Changelog](https://github.com/actions/cache/blob/main/RELEASES.md) - [Commits](https://github.com/actions/cache/compare/v2...v3) --- updated-dependencies: - dependency-name: actions/cache dependency-type: direct:production update-type: version-update:semver-major ... Signed-off-by: dependabot[bot] --- .github/workflows/unittest-macos.yml | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/.github/workflows/unittest-macos.yml b/.github/workflows/unittest-macos.yml index 9b8e79425c..e6e5ccfdc8 100644 --- a/.github/workflows/unittest-macos.yml +++ b/.github/workflows/unittest-macos.yml @@ -28,7 +28,7 @@ jobs: run: mkdir build - name: Set up ccache - uses: actions/cache@v2 + uses: actions/cache@v3 with: path: ${{ env.CCACHE_DIR }} key: macos-ccache-${{ github.sha }} From 4dbecbba51c4c2e1e9465e97a7ab79aa5c536ad0 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Thu, 16 Jun 2022 16:07:40 -0600 Subject: [PATCH 377/585] more work on examples --- examples/mdi/README | 6 +- examples/mdi/Run.sh | 16 +- examples/mdi/aimd_driver.py | 6 +- examples/mdi/data.series.0.7 | 1018 +++++++++++++++++++++ examples/mdi/data.series.0.8 | 1018 +++++++++++++++++++++ examples/mdi/data.series.0.9 | 1018 +++++++++++++++++++++ examples/mdi/data.snapshot | 1018 +++++++++++++++++++++ examples/mdi/in.aimd.alone | 2 +- examples/mdi/in.aimd.driver | 2 +- examples/mdi/in.aimd.driver.plugin | 2 +- examples/mdi/in.aimd.engine | 3 + examples/mdi/{in.aimd.mm => in.aimdpy.mm} | 0 examples/mdi/{in.aimd.qm => in.aimdpy.qm} | 0 examples/mdi/in.series.alone | 6 +- examples/mdi/in.series.driver | 10 +- examples/mdi/in.series.driver.plugin | 10 +- examples/mdi/in.snapshot.alone | 14 +- examples/mdi/in.snapshot.driver | 20 +- examples/mdi/in.snapshot.driver.plugin | 16 +- src/MDI/fix_mdi_qm.cpp | 12 +- 20 files changed, 4124 insertions(+), 73 deletions(-) create mode 100644 examples/mdi/data.series.0.7 create mode 100644 examples/mdi/data.series.0.8 create mode 100644 examples/mdi/data.series.0.9 create mode 100644 examples/mdi/data.snapshot rename examples/mdi/{in.aimd.mm => in.aimdpy.mm} (100%) rename examples/mdi/{in.aimd.qm => in.aimdpy.qm} (100%) diff --git a/examples/mdi/README b/examples/mdi/README index 9380e2e79a..9ab3a3baf6 100644 --- a/examples/mdi/README +++ b/examples/mdi/README @@ -36,7 +36,7 @@ using same the same version of MPI. 5 use-case examples are explained below. See the Run.sh file for commands to run each of the examples -in all the different modes. +in all the different modes. Type "sh Run.sh" to run them all. In the first 3 examples, results running with MDI should be identical to running without MDI (alone log files). Example #4 has no non-MDI @@ -130,5 +130,5 @@ used to link to the 2 engines as a plugin libraries. The example run commands below use the default values of the optional switch. The switch is also explained the top of the file; the info is copied here: -# -nsteps 5 -# number of timesteps in dynamics runs, default = 5 +# -nsteps 10 +# number of timesteps in dynamics runs, default = 10 diff --git a/examples/mdi/Run.sh b/examples/mdi/Run.sh index 55c5638841..934b25d4e1 100644 --- a/examples/mdi/Run.sh +++ b/examples/mdi/Run.sh @@ -227,30 +227,30 @@ mpirun -np 3 python3 sequence_driver.py -plugin lammps -mdi "-role DRIVER -name # Run with TCP: 1 proc each -python3 aimd_driver.py -mdi "-role DRIVER -name aimd -method TCP -port 8021" & +python3 aimd_driver.py -mdi "-role DRIVER -name aimdpy -method TCP -port 8021" > log.aimdpy.driver.tcp.1 & -lmp_mpi -mdi "-role ENGINE -name MM -method TCP -port 8021 -hostname localhost" -log log.aimdpy.mm.tcp.1 -in in.aimd.mm & +lmp_mpi -mdi "-role ENGINE -name MM -method TCP -port 8021 -hostname localhost" -log log.aimdpy.mm.tcp.1 -in in.aimdpy.mm & -lmp_mpi -mdi "-role ENGINE -name QM -method TCP -port 8021 -hostname localhost" -log log.aimdpy.qm.tcp.1 -in in.aimd.qm +lmp_mpi -mdi "-role ENGINE -name QM -method TCP -port 8021 -hostname localhost" -log log.aimdpy.qm.tcp.1 -in in.aimdpy.qm # --- # Run with TCP: 2 procs + 2 procs + 3 procs -mpirun -np 2 python3 aimd_driver.py -mdi "-role DRIVER -name aimd -method TCP -port 8021" & +mpirun -np 2 python3 aimd_driver.py -mdi "-role DRIVER -name aimdpy -method TCP -port 8021" > log.aimdpy.driver.tcp.2 & -mpirun -np 2 lmp_mpi -mdi "-role ENGINE -name MM -method TCP -port 8021 -hostname localhost" -log log.aimd.mm.tcp.2 -in in.aimd.mm & +mpirun -np 2 lmp_mpi -mdi "-role ENGINE -name MM -method TCP -port 8021 -hostname localhost" -log log.aimdpy.mm.tcp.2 -in in.aimdpy.mm & -mpirun -np 3 lmp_mpi -mdi "-role ENGINE -name QM -method TCP -port 8021 -hostname localhost" -log log.aimd.qm.tcp.3 -in in.aimd.qm +mpirun -np 3 lmp_mpi -mdi "-role ENGINE -name QM -method TCP -port 8021 -hostname localhost" -log log.aimdpy.qm.tcp.3 -in in.aimdpy.qm # --- # Run with MPI: 1 proc each -mpirun -np 1 python3 aimd_driver.py -mdi "-role DRIVER -name aimd -method MPI" : -np 1 lmp_mpi -mdi "-role ENGINE -name MM -method MPI" -log log.aimd.mm.mpi.1 -in in.aimd.mm : -np 1 lmp_mpi -mdi "-role ENGINE -name QM -method MPI" -log log.aimd.qm.qm.1 -in in.aimd.qm +mpirun -np 1 python3 aimd_driver.py -mdi "-role DRIVER -name aimdpy -method MPI" : -np 1 lmp_mpi -mdi "-role ENGINE -name MM -method MPI" -log log.aimdpy.mm.mpi.1 -in in.aimdpy.mm : -np 1 lmp_mpi -mdi "-role ENGINE -name QM -method MPI" -log log.aimdpy.qm.mpi.1 -in in.aimdpy.qm > log.aimdpy.driver.mpi.1 # --- # Run with MPI: 2 procs + 2 procs + 3 procs -mpirun -np 2 python3 aimd_driver.py -mdi "-role DRIVER -name aimd -method MPI" : -np 2 lmp_mpi -mdi "-role ENGINE -name MM -method MPI" -log log.aimd.mm.mpi.2 -in in.aimd.mm : -np 3 lmp_mpi -mdi "-role ENGINE -name QM -method MPI" -log log.aimd.qm.mpi.3 -in in.aimd.qm +mpirun -np 2 python3 aimd_driver.py -mdi "-role DRIVER -name aimdpy -method MPI" : -np 2 lmp_mpi -mdi "-role ENGINE -name MM -method MPI" -log log.aimdpy.mm.mpi.2 -in in.aimdpy.mm : -np 3 lmp_mpi -mdi "-role ENGINE -name QM -method MPI" -log log.aimdpy.qm.mpi.3 -in in.aimdpy.qm > log.aimdpy.driver.mpi.2 diff --git a/examples/mdi/aimd_driver.py b/examples/mdi/aimd_driver.py index 2d8fe10c1a..cb01a85e42 100644 --- a/examples/mdi/aimd_driver.py +++ b/examples/mdi/aimd_driver.py @@ -23,8 +23,8 @@ # -plugin_args arglist # args to add when launching plugin library, only when using plugin mode # enclose arglist in quotes if multiple words -# -nsteps 5 -# number of timesteps, default = 5 +# -nsteps 10 +# number of timesteps, default = 10 import sys,math,random import mdi @@ -183,7 +183,7 @@ mdiarg = "" plugin = "" plugin_args = "" -nsteps = 5 +nsteps = 10 # parse command-line args diff --git a/examples/mdi/data.series.0.7 b/examples/mdi/data.series.0.7 new file mode 100644 index 0000000000..641d8b07c9 --- /dev/null +++ b/examples/mdi/data.series.0.7 @@ -0,0 +1,1018 @@ +LAMMPS data file via write_data, version 2 Jun 2022, timestep = 0 + +500 atoms +1 atom types + +0 8.939035350965677 xlo xhi +0 8.939035350965677 ylo yhi +0 8.939035350965677 zlo zhi + +Masses + +1 1 + +Atoms # atomic + +1 1 0 0 0 0 0 0 +2 1 0.8939035350965676 0.8939035350965676 0 0 0 0 +3 1 0.8939035350965676 0 0.8939035350965676 0 0 0 +4 1 0 0.8939035350965676 0.8939035350965676 0 0 0 +5 1 1.7878070701931352 0 0 0 0 0 +6 1 2.6817106052897026 0.8939035350965676 0 0 0 0 +7 1 2.6817106052897026 0 0.8939035350965676 0 0 0 +8 1 1.7878070701931352 0.8939035350965676 0.8939035350965676 0 0 0 +9 1 3.5756141403862705 0 0 0 0 0 +10 1 4.469517675482838 0.8939035350965676 0 0 0 0 +11 1 4.469517675482838 0 0.8939035350965676 0 0 0 +12 1 3.5756141403862705 0.8939035350965676 0.8939035350965676 0 0 0 +13 1 5.363421210579405 0 0 0 0 0 +14 1 6.257324745675973 0.8939035350965676 0 0 0 0 +15 1 6.257324745675973 0 0.8939035350965676 0 0 0 +16 1 5.363421210579405 0.8939035350965676 0.8939035350965676 0 0 0 +17 1 7.151228280772541 0 0 0 0 0 +18 1 8.045131815869109 0.8939035350965676 0 0 0 0 +19 1 8.045131815869109 0 0.8939035350965676 0 0 0 +20 1 7.151228280772541 0.8939035350965676 0.8939035350965676 0 0 0 +21 1 0 1.7878070701931352 0 0 0 0 +22 1 0.8939035350965676 2.6817106052897026 0 0 0 0 +23 1 0.8939035350965676 1.7878070701931352 0.8939035350965676 0 0 0 +24 1 0 2.6817106052897026 0.8939035350965676 0 0 0 +25 1 1.7878070701931352 1.7878070701931352 0 0 0 0 +26 1 2.6817106052897026 2.6817106052897026 0 0 0 0 +27 1 2.6817106052897026 1.7878070701931352 0.8939035350965676 0 0 0 +28 1 1.7878070701931352 2.6817106052897026 0.8939035350965676 0 0 0 +29 1 3.5756141403862705 1.7878070701931352 0 0 0 0 +30 1 4.469517675482838 2.6817106052897026 0 0 0 0 +31 1 4.469517675482838 1.7878070701931352 0.8939035350965676 0 0 0 +32 1 3.5756141403862705 2.6817106052897026 0.8939035350965676 0 0 0 +33 1 5.363421210579405 1.7878070701931352 0 0 0 0 +34 1 6.257324745675973 2.6817106052897026 0 0 0 0 +35 1 6.257324745675973 1.7878070701931352 0.8939035350965676 0 0 0 +36 1 5.363421210579405 2.6817106052897026 0.8939035350965676 0 0 0 +37 1 7.151228280772541 1.7878070701931352 0 0 0 0 +38 1 8.045131815869109 2.6817106052897026 0 0 0 0 +39 1 8.045131815869109 1.7878070701931352 0.8939035350965676 0 0 0 +40 1 7.151228280772541 2.6817106052897026 0.8939035350965676 0 0 0 +41 1 0 3.5756141403862705 0 0 0 0 +42 1 0.8939035350965676 4.469517675482838 0 0 0 0 +43 1 0.8939035350965676 3.5756141403862705 0.8939035350965676 0 0 0 +44 1 0 4.469517675482838 0.8939035350965676 0 0 0 +45 1 1.7878070701931352 3.5756141403862705 0 0 0 0 +46 1 2.6817106052897026 4.469517675482838 0 0 0 0 +47 1 2.6817106052897026 3.5756141403862705 0.8939035350965676 0 0 0 +48 1 1.7878070701931352 4.469517675482838 0.8939035350965676 0 0 0 +49 1 3.5756141403862705 3.5756141403862705 0 0 0 0 +50 1 4.469517675482838 4.469517675482838 0 0 0 0 +51 1 4.469517675482838 3.5756141403862705 0.8939035350965676 0 0 0 +52 1 3.5756141403862705 4.469517675482838 0.8939035350965676 0 0 0 +53 1 5.363421210579405 3.5756141403862705 0 0 0 0 +54 1 6.257324745675973 4.469517675482838 0 0 0 0 +55 1 6.257324745675973 3.5756141403862705 0.8939035350965676 0 0 0 +56 1 5.363421210579405 4.469517675482838 0.8939035350965676 0 0 0 +57 1 7.151228280772541 3.5756141403862705 0 0 0 0 +58 1 8.045131815869109 4.469517675482838 0 0 0 0 +59 1 8.045131815869109 3.5756141403862705 0.8939035350965676 0 0 0 +60 1 7.151228280772541 4.469517675482838 0.8939035350965676 0 0 0 +61 1 0 5.363421210579405 0 0 0 0 +62 1 0.8939035350965676 6.257324745675973 0 0 0 0 +63 1 0.8939035350965676 5.363421210579405 0.8939035350965676 0 0 0 +64 1 0 6.257324745675973 0.8939035350965676 0 0 0 +65 1 1.7878070701931352 5.363421210579405 0 0 0 0 +66 1 2.6817106052897026 6.257324745675973 0 0 0 0 +67 1 2.6817106052897026 5.363421210579405 0.8939035350965676 0 0 0 +68 1 1.7878070701931352 6.257324745675973 0.8939035350965676 0 0 0 +69 1 3.5756141403862705 5.363421210579405 0 0 0 0 +70 1 4.469517675482838 6.257324745675973 0 0 0 0 +71 1 4.469517675482838 5.363421210579405 0.8939035350965676 0 0 0 +72 1 3.5756141403862705 6.257324745675973 0.8939035350965676 0 0 0 +73 1 5.363421210579405 5.363421210579405 0 0 0 0 +74 1 6.257324745675973 6.257324745675973 0 0 0 0 +75 1 6.257324745675973 5.363421210579405 0.8939035350965676 0 0 0 +76 1 5.363421210579405 6.257324745675973 0.8939035350965676 0 0 0 +77 1 7.151228280772541 5.363421210579405 0 0 0 0 +78 1 8.045131815869109 6.257324745675973 0 0 0 0 +79 1 8.045131815869109 5.363421210579405 0.8939035350965676 0 0 0 +80 1 7.151228280772541 6.257324745675973 0.8939035350965676 0 0 0 +81 1 0 7.151228280772541 0 0 0 0 +82 1 0.8939035350965676 8.045131815869109 0 0 0 0 +83 1 0.8939035350965676 7.151228280772541 0.8939035350965676 0 0 0 +84 1 0 8.045131815869109 0.8939035350965676 0 0 0 +85 1 1.7878070701931352 7.151228280772541 0 0 0 0 +86 1 2.6817106052897026 8.045131815869109 0 0 0 0 +87 1 2.6817106052897026 7.151228280772541 0.8939035350965676 0 0 0 +88 1 1.7878070701931352 8.045131815869109 0.8939035350965676 0 0 0 +89 1 3.5756141403862705 7.151228280772541 0 0 0 0 +90 1 4.469517675482838 8.045131815869109 0 0 0 0 +91 1 4.469517675482838 7.151228280772541 0.8939035350965676 0 0 0 +92 1 3.5756141403862705 8.045131815869109 0.8939035350965676 0 0 0 +93 1 5.363421210579405 7.151228280772541 0 0 0 0 +94 1 6.257324745675973 8.045131815869109 0 0 0 0 +95 1 6.257324745675973 7.151228280772541 0.8939035350965676 0 0 0 +96 1 5.363421210579405 8.045131815869109 0.8939035350965676 0 0 0 +97 1 7.151228280772541 7.151228280772541 0 0 0 0 +98 1 8.045131815869109 8.045131815869109 0 0 0 0 +99 1 8.045131815869109 7.151228280772541 0.8939035350965676 0 0 0 +100 1 7.151228280772541 8.045131815869109 0.8939035350965676 0 0 0 +101 1 0 0 1.7878070701931352 0 0 0 +102 1 0.8939035350965676 0.8939035350965676 1.7878070701931352 0 0 0 +103 1 0.8939035350965676 0 2.6817106052897026 0 0 0 +104 1 0 0.8939035350965676 2.6817106052897026 0 0 0 +105 1 1.7878070701931352 0 1.7878070701931352 0 0 0 +106 1 2.6817106052897026 0.8939035350965676 1.7878070701931352 0 0 0 +107 1 2.6817106052897026 0 2.6817106052897026 0 0 0 +108 1 1.7878070701931352 0.8939035350965676 2.6817106052897026 0 0 0 +109 1 3.5756141403862705 0 1.7878070701931352 0 0 0 +110 1 4.469517675482838 0.8939035350965676 1.7878070701931352 0 0 0 +111 1 4.469517675482838 0 2.6817106052897026 0 0 0 +112 1 3.5756141403862705 0.8939035350965676 2.6817106052897026 0 0 0 +113 1 5.363421210579405 0 1.7878070701931352 0 0 0 +114 1 6.257324745675973 0.8939035350965676 1.7878070701931352 0 0 0 +115 1 6.257324745675973 0 2.6817106052897026 0 0 0 +116 1 5.363421210579405 0.8939035350965676 2.6817106052897026 0 0 0 +117 1 7.151228280772541 0 1.7878070701931352 0 0 0 +118 1 8.045131815869109 0.8939035350965676 1.7878070701931352 0 0 0 +119 1 8.045131815869109 0 2.6817106052897026 0 0 0 +120 1 7.151228280772541 0.8939035350965676 2.6817106052897026 0 0 0 +121 1 0 1.7878070701931352 1.7878070701931352 0 0 0 +122 1 0.8939035350965676 2.6817106052897026 1.7878070701931352 0 0 0 +123 1 0.8939035350965676 1.7878070701931352 2.6817106052897026 0 0 0 +124 1 0 2.6817106052897026 2.6817106052897026 0 0 0 +125 1 1.7878070701931352 1.7878070701931352 1.7878070701931352 0 0 0 +126 1 2.6817106052897026 2.6817106052897026 1.7878070701931352 0 0 0 +127 1 2.6817106052897026 1.7878070701931352 2.6817106052897026 0 0 0 +128 1 1.7878070701931352 2.6817106052897026 2.6817106052897026 0 0 0 +129 1 3.5756141403862705 1.7878070701931352 1.7878070701931352 0 0 0 +130 1 4.469517675482838 2.6817106052897026 1.7878070701931352 0 0 0 +131 1 4.469517675482838 1.7878070701931352 2.6817106052897026 0 0 0 +132 1 3.5756141403862705 2.6817106052897026 2.6817106052897026 0 0 0 +133 1 5.363421210579405 1.7878070701931352 1.7878070701931352 0 0 0 +134 1 6.257324745675973 2.6817106052897026 1.7878070701931352 0 0 0 +135 1 6.257324745675973 1.7878070701931352 2.6817106052897026 0 0 0 +136 1 5.363421210579405 2.6817106052897026 2.6817106052897026 0 0 0 +137 1 7.151228280772541 1.7878070701931352 1.7878070701931352 0 0 0 +138 1 8.045131815869109 2.6817106052897026 1.7878070701931352 0 0 0 +139 1 8.045131815869109 1.7878070701931352 2.6817106052897026 0 0 0 +140 1 7.151228280772541 2.6817106052897026 2.6817106052897026 0 0 0 +141 1 0 3.5756141403862705 1.7878070701931352 0 0 0 +142 1 0.8939035350965676 4.469517675482838 1.7878070701931352 0 0 0 +143 1 0.8939035350965676 3.5756141403862705 2.6817106052897026 0 0 0 +144 1 0 4.469517675482838 2.6817106052897026 0 0 0 +145 1 1.7878070701931352 3.5756141403862705 1.7878070701931352 0 0 0 +146 1 2.6817106052897026 4.469517675482838 1.7878070701931352 0 0 0 +147 1 2.6817106052897026 3.5756141403862705 2.6817106052897026 0 0 0 +148 1 1.7878070701931352 4.469517675482838 2.6817106052897026 0 0 0 +149 1 3.5756141403862705 3.5756141403862705 1.7878070701931352 0 0 0 +150 1 4.469517675482838 4.469517675482838 1.7878070701931352 0 0 0 +151 1 4.469517675482838 3.5756141403862705 2.6817106052897026 0 0 0 +152 1 3.5756141403862705 4.469517675482838 2.6817106052897026 0 0 0 +153 1 5.363421210579405 3.5756141403862705 1.7878070701931352 0 0 0 +154 1 6.257324745675973 4.469517675482838 1.7878070701931352 0 0 0 +155 1 6.257324745675973 3.5756141403862705 2.6817106052897026 0 0 0 +156 1 5.363421210579405 4.469517675482838 2.6817106052897026 0 0 0 +157 1 7.151228280772541 3.5756141403862705 1.7878070701931352 0 0 0 +158 1 8.045131815869109 4.469517675482838 1.7878070701931352 0 0 0 +159 1 8.045131815869109 3.5756141403862705 2.6817106052897026 0 0 0 +160 1 7.151228280772541 4.469517675482838 2.6817106052897026 0 0 0 +161 1 0 5.363421210579405 1.7878070701931352 0 0 0 +162 1 0.8939035350965676 6.257324745675973 1.7878070701931352 0 0 0 +163 1 0.8939035350965676 5.363421210579405 2.6817106052897026 0 0 0 +164 1 0 6.257324745675973 2.6817106052897026 0 0 0 +165 1 1.7878070701931352 5.363421210579405 1.7878070701931352 0 0 0 +166 1 2.6817106052897026 6.257324745675973 1.7878070701931352 0 0 0 +167 1 2.6817106052897026 5.363421210579405 2.6817106052897026 0 0 0 +168 1 1.7878070701931352 6.257324745675973 2.6817106052897026 0 0 0 +169 1 3.5756141403862705 5.363421210579405 1.7878070701931352 0 0 0 +170 1 4.469517675482838 6.257324745675973 1.7878070701931352 0 0 0 +171 1 4.469517675482838 5.363421210579405 2.6817106052897026 0 0 0 +172 1 3.5756141403862705 6.257324745675973 2.6817106052897026 0 0 0 +173 1 5.363421210579405 5.363421210579405 1.7878070701931352 0 0 0 +174 1 6.257324745675973 6.257324745675973 1.7878070701931352 0 0 0 +175 1 6.257324745675973 5.363421210579405 2.6817106052897026 0 0 0 +176 1 5.363421210579405 6.257324745675973 2.6817106052897026 0 0 0 +177 1 7.151228280772541 5.363421210579405 1.7878070701931352 0 0 0 +178 1 8.045131815869109 6.257324745675973 1.7878070701931352 0 0 0 +179 1 8.045131815869109 5.363421210579405 2.6817106052897026 0 0 0 +180 1 7.151228280772541 6.257324745675973 2.6817106052897026 0 0 0 +181 1 0 7.151228280772541 1.7878070701931352 0 0 0 +182 1 0.8939035350965676 8.045131815869109 1.7878070701931352 0 0 0 +183 1 0.8939035350965676 7.151228280772541 2.6817106052897026 0 0 0 +184 1 0 8.045131815869109 2.6817106052897026 0 0 0 +185 1 1.7878070701931352 7.151228280772541 1.7878070701931352 0 0 0 +186 1 2.6817106052897026 8.045131815869109 1.7878070701931352 0 0 0 +187 1 2.6817106052897026 7.151228280772541 2.6817106052897026 0 0 0 +188 1 1.7878070701931352 8.045131815869109 2.6817106052897026 0 0 0 +189 1 3.5756141403862705 7.151228280772541 1.7878070701931352 0 0 0 +190 1 4.469517675482838 8.045131815869109 1.7878070701931352 0 0 0 +191 1 4.469517675482838 7.151228280772541 2.6817106052897026 0 0 0 +192 1 3.5756141403862705 8.045131815869109 2.6817106052897026 0 0 0 +193 1 5.363421210579405 7.151228280772541 1.7878070701931352 0 0 0 +194 1 6.257324745675973 8.045131815869109 1.7878070701931352 0 0 0 +195 1 6.257324745675973 7.151228280772541 2.6817106052897026 0 0 0 +196 1 5.363421210579405 8.045131815869109 2.6817106052897026 0 0 0 +197 1 7.151228280772541 7.151228280772541 1.7878070701931352 0 0 0 +198 1 8.045131815869109 8.045131815869109 1.7878070701931352 0 0 0 +199 1 8.045131815869109 7.151228280772541 2.6817106052897026 0 0 0 +200 1 7.151228280772541 8.045131815869109 2.6817106052897026 0 0 0 +201 1 0 0 3.5756141403862705 0 0 0 +202 1 0.8939035350965676 0.8939035350965676 3.5756141403862705 0 0 0 +203 1 0.8939035350965676 0 4.469517675482838 0 0 0 +204 1 0 0.8939035350965676 4.469517675482838 0 0 0 +205 1 1.7878070701931352 0 3.5756141403862705 0 0 0 +206 1 2.6817106052897026 0.8939035350965676 3.5756141403862705 0 0 0 +207 1 2.6817106052897026 0 4.469517675482838 0 0 0 +208 1 1.7878070701931352 0.8939035350965676 4.469517675482838 0 0 0 +209 1 3.5756141403862705 0 3.5756141403862705 0 0 0 +210 1 4.469517675482838 0.8939035350965676 3.5756141403862705 0 0 0 +211 1 4.469517675482838 0 4.469517675482838 0 0 0 +212 1 3.5756141403862705 0.8939035350965676 4.469517675482838 0 0 0 +213 1 5.363421210579405 0 3.5756141403862705 0 0 0 +214 1 6.257324745675973 0.8939035350965676 3.5756141403862705 0 0 0 +215 1 6.257324745675973 0 4.469517675482838 0 0 0 +216 1 5.363421210579405 0.8939035350965676 4.469517675482838 0 0 0 +217 1 7.151228280772541 0 3.5756141403862705 0 0 0 +218 1 8.045131815869109 0.8939035350965676 3.5756141403862705 0 0 0 +219 1 8.045131815869109 0 4.469517675482838 0 0 0 +220 1 7.151228280772541 0.8939035350965676 4.469517675482838 0 0 0 +221 1 0 1.7878070701931352 3.5756141403862705 0 0 0 +222 1 0.8939035350965676 2.6817106052897026 3.5756141403862705 0 0 0 +223 1 0.8939035350965676 1.7878070701931352 4.469517675482838 0 0 0 +224 1 0 2.6817106052897026 4.469517675482838 0 0 0 +225 1 1.7878070701931352 1.7878070701931352 3.5756141403862705 0 0 0 +226 1 2.6817106052897026 2.6817106052897026 3.5756141403862705 0 0 0 +227 1 2.6817106052897026 1.7878070701931352 4.469517675482838 0 0 0 +228 1 1.7878070701931352 2.6817106052897026 4.469517675482838 0 0 0 +229 1 3.5756141403862705 1.7878070701931352 3.5756141403862705 0 0 0 +230 1 4.469517675482838 2.6817106052897026 3.5756141403862705 0 0 0 +231 1 4.469517675482838 1.7878070701931352 4.469517675482838 0 0 0 +232 1 3.5756141403862705 2.6817106052897026 4.469517675482838 0 0 0 +233 1 5.363421210579405 1.7878070701931352 3.5756141403862705 0 0 0 +234 1 6.257324745675973 2.6817106052897026 3.5756141403862705 0 0 0 +235 1 6.257324745675973 1.7878070701931352 4.469517675482838 0 0 0 +236 1 5.363421210579405 2.6817106052897026 4.469517675482838 0 0 0 +237 1 7.151228280772541 1.7878070701931352 3.5756141403862705 0 0 0 +238 1 8.045131815869109 2.6817106052897026 3.5756141403862705 0 0 0 +239 1 8.045131815869109 1.7878070701931352 4.469517675482838 0 0 0 +240 1 7.151228280772541 2.6817106052897026 4.469517675482838 0 0 0 +241 1 0 3.5756141403862705 3.5756141403862705 0 0 0 +242 1 0.8939035350965676 4.469517675482838 3.5756141403862705 0 0 0 +243 1 0.8939035350965676 3.5756141403862705 4.469517675482838 0 0 0 +244 1 0 4.469517675482838 4.469517675482838 0 0 0 +245 1 1.7878070701931352 3.5756141403862705 3.5756141403862705 0 0 0 +246 1 2.6817106052897026 4.469517675482838 3.5756141403862705 0 0 0 +247 1 2.6817106052897026 3.5756141403862705 4.469517675482838 0 0 0 +248 1 1.7878070701931352 4.469517675482838 4.469517675482838 0 0 0 +249 1 3.5756141403862705 3.5756141403862705 3.5756141403862705 0 0 0 +250 1 4.469517675482838 4.469517675482838 3.5756141403862705 0 0 0 +251 1 4.469517675482838 3.5756141403862705 4.469517675482838 0 0 0 +252 1 3.5756141403862705 4.469517675482838 4.469517675482838 0 0 0 +253 1 5.363421210579405 3.5756141403862705 3.5756141403862705 0 0 0 +254 1 6.257324745675973 4.469517675482838 3.5756141403862705 0 0 0 +255 1 6.257324745675973 3.5756141403862705 4.469517675482838 0 0 0 +256 1 5.363421210579405 4.469517675482838 4.469517675482838 0 0 0 +257 1 7.151228280772541 3.5756141403862705 3.5756141403862705 0 0 0 +258 1 8.045131815869109 4.469517675482838 3.5756141403862705 0 0 0 +259 1 8.045131815869109 3.5756141403862705 4.469517675482838 0 0 0 +260 1 7.151228280772541 4.469517675482838 4.469517675482838 0 0 0 +261 1 0 5.363421210579405 3.5756141403862705 0 0 0 +262 1 0.8939035350965676 6.257324745675973 3.5756141403862705 0 0 0 +263 1 0.8939035350965676 5.363421210579405 4.469517675482838 0 0 0 +264 1 0 6.257324745675973 4.469517675482838 0 0 0 +265 1 1.7878070701931352 5.363421210579405 3.5756141403862705 0 0 0 +266 1 2.6817106052897026 6.257324745675973 3.5756141403862705 0 0 0 +267 1 2.6817106052897026 5.363421210579405 4.469517675482838 0 0 0 +268 1 1.7878070701931352 6.257324745675973 4.469517675482838 0 0 0 +269 1 3.5756141403862705 5.363421210579405 3.5756141403862705 0 0 0 +270 1 4.469517675482838 6.257324745675973 3.5756141403862705 0 0 0 +271 1 4.469517675482838 5.363421210579405 4.469517675482838 0 0 0 +272 1 3.5756141403862705 6.257324745675973 4.469517675482838 0 0 0 +273 1 5.363421210579405 5.363421210579405 3.5756141403862705 0 0 0 +274 1 6.257324745675973 6.257324745675973 3.5756141403862705 0 0 0 +275 1 6.257324745675973 5.363421210579405 4.469517675482838 0 0 0 +276 1 5.363421210579405 6.257324745675973 4.469517675482838 0 0 0 +277 1 7.151228280772541 5.363421210579405 3.5756141403862705 0 0 0 +278 1 8.045131815869109 6.257324745675973 3.5756141403862705 0 0 0 +279 1 8.045131815869109 5.363421210579405 4.469517675482838 0 0 0 +280 1 7.151228280772541 6.257324745675973 4.469517675482838 0 0 0 +281 1 0 7.151228280772541 3.5756141403862705 0 0 0 +282 1 0.8939035350965676 8.045131815869109 3.5756141403862705 0 0 0 +283 1 0.8939035350965676 7.151228280772541 4.469517675482838 0 0 0 +284 1 0 8.045131815869109 4.469517675482838 0 0 0 +285 1 1.7878070701931352 7.151228280772541 3.5756141403862705 0 0 0 +286 1 2.6817106052897026 8.045131815869109 3.5756141403862705 0 0 0 +287 1 2.6817106052897026 7.151228280772541 4.469517675482838 0 0 0 +288 1 1.7878070701931352 8.045131815869109 4.469517675482838 0 0 0 +289 1 3.5756141403862705 7.151228280772541 3.5756141403862705 0 0 0 +290 1 4.469517675482838 8.045131815869109 3.5756141403862705 0 0 0 +291 1 4.469517675482838 7.151228280772541 4.469517675482838 0 0 0 +292 1 3.5756141403862705 8.045131815869109 4.469517675482838 0 0 0 +293 1 5.363421210579405 7.151228280772541 3.5756141403862705 0 0 0 +294 1 6.257324745675973 8.045131815869109 3.5756141403862705 0 0 0 +295 1 6.257324745675973 7.151228280772541 4.469517675482838 0 0 0 +296 1 5.363421210579405 8.045131815869109 4.469517675482838 0 0 0 +297 1 7.151228280772541 7.151228280772541 3.5756141403862705 0 0 0 +298 1 8.045131815869109 8.045131815869109 3.5756141403862705 0 0 0 +299 1 8.045131815869109 7.151228280772541 4.469517675482838 0 0 0 +300 1 7.151228280772541 8.045131815869109 4.469517675482838 0 0 0 +301 1 0 0 5.363421210579405 0 0 0 +302 1 0.8939035350965676 0.8939035350965676 5.363421210579405 0 0 0 +303 1 0.8939035350965676 0 6.257324745675973 0 0 0 +304 1 0 0.8939035350965676 6.257324745675973 0 0 0 +305 1 1.7878070701931352 0 5.363421210579405 0 0 0 +306 1 2.6817106052897026 0.8939035350965676 5.363421210579405 0 0 0 +307 1 2.6817106052897026 0 6.257324745675973 0 0 0 +308 1 1.7878070701931352 0.8939035350965676 6.257324745675973 0 0 0 +309 1 3.5756141403862705 0 5.363421210579405 0 0 0 +310 1 4.469517675482838 0.8939035350965676 5.363421210579405 0 0 0 +311 1 4.469517675482838 0 6.257324745675973 0 0 0 +312 1 3.5756141403862705 0.8939035350965676 6.257324745675973 0 0 0 +313 1 5.363421210579405 0 5.363421210579405 0 0 0 +314 1 6.257324745675973 0.8939035350965676 5.363421210579405 0 0 0 +315 1 6.257324745675973 0 6.257324745675973 0 0 0 +316 1 5.363421210579405 0.8939035350965676 6.257324745675973 0 0 0 +317 1 7.151228280772541 0 5.363421210579405 0 0 0 +318 1 8.045131815869109 0.8939035350965676 5.363421210579405 0 0 0 +319 1 8.045131815869109 0 6.257324745675973 0 0 0 +320 1 7.151228280772541 0.8939035350965676 6.257324745675973 0 0 0 +321 1 0 1.7878070701931352 5.363421210579405 0 0 0 +322 1 0.8939035350965676 2.6817106052897026 5.363421210579405 0 0 0 +323 1 0.8939035350965676 1.7878070701931352 6.257324745675973 0 0 0 +324 1 0 2.6817106052897026 6.257324745675973 0 0 0 +325 1 1.7878070701931352 1.7878070701931352 5.363421210579405 0 0 0 +326 1 2.6817106052897026 2.6817106052897026 5.363421210579405 0 0 0 +327 1 2.6817106052897026 1.7878070701931352 6.257324745675973 0 0 0 +328 1 1.7878070701931352 2.6817106052897026 6.257324745675973 0 0 0 +329 1 3.5756141403862705 1.7878070701931352 5.363421210579405 0 0 0 +330 1 4.469517675482838 2.6817106052897026 5.363421210579405 0 0 0 +331 1 4.469517675482838 1.7878070701931352 6.257324745675973 0 0 0 +332 1 3.5756141403862705 2.6817106052897026 6.257324745675973 0 0 0 +333 1 5.363421210579405 1.7878070701931352 5.363421210579405 0 0 0 +334 1 6.257324745675973 2.6817106052897026 5.363421210579405 0 0 0 +335 1 6.257324745675973 1.7878070701931352 6.257324745675973 0 0 0 +336 1 5.363421210579405 2.6817106052897026 6.257324745675973 0 0 0 +337 1 7.151228280772541 1.7878070701931352 5.363421210579405 0 0 0 +338 1 8.045131815869109 2.6817106052897026 5.363421210579405 0 0 0 +339 1 8.045131815869109 1.7878070701931352 6.257324745675973 0 0 0 +340 1 7.151228280772541 2.6817106052897026 6.257324745675973 0 0 0 +341 1 0 3.5756141403862705 5.363421210579405 0 0 0 +342 1 0.8939035350965676 4.469517675482838 5.363421210579405 0 0 0 +343 1 0.8939035350965676 3.5756141403862705 6.257324745675973 0 0 0 +344 1 0 4.469517675482838 6.257324745675973 0 0 0 +345 1 1.7878070701931352 3.5756141403862705 5.363421210579405 0 0 0 +346 1 2.6817106052897026 4.469517675482838 5.363421210579405 0 0 0 +347 1 2.6817106052897026 3.5756141403862705 6.257324745675973 0 0 0 +348 1 1.7878070701931352 4.469517675482838 6.257324745675973 0 0 0 +349 1 3.5756141403862705 3.5756141403862705 5.363421210579405 0 0 0 +350 1 4.469517675482838 4.469517675482838 5.363421210579405 0 0 0 +351 1 4.469517675482838 3.5756141403862705 6.257324745675973 0 0 0 +352 1 3.5756141403862705 4.469517675482838 6.257324745675973 0 0 0 +353 1 5.363421210579405 3.5756141403862705 5.363421210579405 0 0 0 +354 1 6.257324745675973 4.469517675482838 5.363421210579405 0 0 0 +355 1 6.257324745675973 3.5756141403862705 6.257324745675973 0 0 0 +356 1 5.363421210579405 4.469517675482838 6.257324745675973 0 0 0 +357 1 7.151228280772541 3.5756141403862705 5.363421210579405 0 0 0 +358 1 8.045131815869109 4.469517675482838 5.363421210579405 0 0 0 +359 1 8.045131815869109 3.5756141403862705 6.257324745675973 0 0 0 +360 1 7.151228280772541 4.469517675482838 6.257324745675973 0 0 0 +361 1 0 5.363421210579405 5.363421210579405 0 0 0 +362 1 0.8939035350965676 6.257324745675973 5.363421210579405 0 0 0 +363 1 0.8939035350965676 5.363421210579405 6.257324745675973 0 0 0 +364 1 0 6.257324745675973 6.257324745675973 0 0 0 +365 1 1.7878070701931352 5.363421210579405 5.363421210579405 0 0 0 +366 1 2.6817106052897026 6.257324745675973 5.363421210579405 0 0 0 +367 1 2.6817106052897026 5.363421210579405 6.257324745675973 0 0 0 +368 1 1.7878070701931352 6.257324745675973 6.257324745675973 0 0 0 +369 1 3.5756141403862705 5.363421210579405 5.363421210579405 0 0 0 +370 1 4.469517675482838 6.257324745675973 5.363421210579405 0 0 0 +371 1 4.469517675482838 5.363421210579405 6.257324745675973 0 0 0 +372 1 3.5756141403862705 6.257324745675973 6.257324745675973 0 0 0 +373 1 5.363421210579405 5.363421210579405 5.363421210579405 0 0 0 +374 1 6.257324745675973 6.257324745675973 5.363421210579405 0 0 0 +375 1 6.257324745675973 5.363421210579405 6.257324745675973 0 0 0 +376 1 5.363421210579405 6.257324745675973 6.257324745675973 0 0 0 +377 1 7.151228280772541 5.363421210579405 5.363421210579405 0 0 0 +378 1 8.045131815869109 6.257324745675973 5.363421210579405 0 0 0 +379 1 8.045131815869109 5.363421210579405 6.257324745675973 0 0 0 +380 1 7.151228280772541 6.257324745675973 6.257324745675973 0 0 0 +381 1 0 7.151228280772541 5.363421210579405 0 0 0 +382 1 0.8939035350965676 8.045131815869109 5.363421210579405 0 0 0 +383 1 0.8939035350965676 7.151228280772541 6.257324745675973 0 0 0 +384 1 0 8.045131815869109 6.257324745675973 0 0 0 +385 1 1.7878070701931352 7.151228280772541 5.363421210579405 0 0 0 +386 1 2.6817106052897026 8.045131815869109 5.363421210579405 0 0 0 +387 1 2.6817106052897026 7.151228280772541 6.257324745675973 0 0 0 +388 1 1.7878070701931352 8.045131815869109 6.257324745675973 0 0 0 +389 1 3.5756141403862705 7.151228280772541 5.363421210579405 0 0 0 +390 1 4.469517675482838 8.045131815869109 5.363421210579405 0 0 0 +391 1 4.469517675482838 7.151228280772541 6.257324745675973 0 0 0 +392 1 3.5756141403862705 8.045131815869109 6.257324745675973 0 0 0 +393 1 5.363421210579405 7.151228280772541 5.363421210579405 0 0 0 +394 1 6.257324745675973 8.045131815869109 5.363421210579405 0 0 0 +395 1 6.257324745675973 7.151228280772541 6.257324745675973 0 0 0 +396 1 5.363421210579405 8.045131815869109 6.257324745675973 0 0 0 +397 1 7.151228280772541 7.151228280772541 5.363421210579405 0 0 0 +398 1 8.045131815869109 8.045131815869109 5.363421210579405 0 0 0 +399 1 8.045131815869109 7.151228280772541 6.257324745675973 0 0 0 +400 1 7.151228280772541 8.045131815869109 6.257324745675973 0 0 0 +401 1 0 0 7.151228280772541 0 0 0 +402 1 0.8939035350965676 0.8939035350965676 7.151228280772541 0 0 0 +403 1 0.8939035350965676 0 8.045131815869109 0 0 0 +404 1 0 0.8939035350965676 8.045131815869109 0 0 0 +405 1 1.7878070701931352 0 7.151228280772541 0 0 0 +406 1 2.6817106052897026 0.8939035350965676 7.151228280772541 0 0 0 +407 1 2.6817106052897026 0 8.045131815869109 0 0 0 +408 1 1.7878070701931352 0.8939035350965676 8.045131815869109 0 0 0 +409 1 3.5756141403862705 0 7.151228280772541 0 0 0 +410 1 4.469517675482838 0.8939035350965676 7.151228280772541 0 0 0 +411 1 4.469517675482838 0 8.045131815869109 0 0 0 +412 1 3.5756141403862705 0.8939035350965676 8.045131815869109 0 0 0 +413 1 5.363421210579405 0 7.151228280772541 0 0 0 +414 1 6.257324745675973 0.8939035350965676 7.151228280772541 0 0 0 +415 1 6.257324745675973 0 8.045131815869109 0 0 0 +416 1 5.363421210579405 0.8939035350965676 8.045131815869109 0 0 0 +417 1 7.151228280772541 0 7.151228280772541 0 0 0 +418 1 8.045131815869109 0.8939035350965676 7.151228280772541 0 0 0 +419 1 8.045131815869109 0 8.045131815869109 0 0 0 +420 1 7.151228280772541 0.8939035350965676 8.045131815869109 0 0 0 +421 1 0 1.7878070701931352 7.151228280772541 0 0 0 +422 1 0.8939035350965676 2.6817106052897026 7.151228280772541 0 0 0 +423 1 0.8939035350965676 1.7878070701931352 8.045131815869109 0 0 0 +424 1 0 2.6817106052897026 8.045131815869109 0 0 0 +425 1 1.7878070701931352 1.7878070701931352 7.151228280772541 0 0 0 +426 1 2.6817106052897026 2.6817106052897026 7.151228280772541 0 0 0 +427 1 2.6817106052897026 1.7878070701931352 8.045131815869109 0 0 0 +428 1 1.7878070701931352 2.6817106052897026 8.045131815869109 0 0 0 +429 1 3.5756141403862705 1.7878070701931352 7.151228280772541 0 0 0 +430 1 4.469517675482838 2.6817106052897026 7.151228280772541 0 0 0 +431 1 4.469517675482838 1.7878070701931352 8.045131815869109 0 0 0 +432 1 3.5756141403862705 2.6817106052897026 8.045131815869109 0 0 0 +433 1 5.363421210579405 1.7878070701931352 7.151228280772541 0 0 0 +434 1 6.257324745675973 2.6817106052897026 7.151228280772541 0 0 0 +435 1 6.257324745675973 1.7878070701931352 8.045131815869109 0 0 0 +436 1 5.363421210579405 2.6817106052897026 8.045131815869109 0 0 0 +437 1 7.151228280772541 1.7878070701931352 7.151228280772541 0 0 0 +438 1 8.045131815869109 2.6817106052897026 7.151228280772541 0 0 0 +439 1 8.045131815869109 1.7878070701931352 8.045131815869109 0 0 0 +440 1 7.151228280772541 2.6817106052897026 8.045131815869109 0 0 0 +441 1 0 3.5756141403862705 7.151228280772541 0 0 0 +442 1 0.8939035350965676 4.469517675482838 7.151228280772541 0 0 0 +443 1 0.8939035350965676 3.5756141403862705 8.045131815869109 0 0 0 +444 1 0 4.469517675482838 8.045131815869109 0 0 0 +445 1 1.7878070701931352 3.5756141403862705 7.151228280772541 0 0 0 +446 1 2.6817106052897026 4.469517675482838 7.151228280772541 0 0 0 +447 1 2.6817106052897026 3.5756141403862705 8.045131815869109 0 0 0 +448 1 1.7878070701931352 4.469517675482838 8.045131815869109 0 0 0 +449 1 3.5756141403862705 3.5756141403862705 7.151228280772541 0 0 0 +450 1 4.469517675482838 4.469517675482838 7.151228280772541 0 0 0 +451 1 4.469517675482838 3.5756141403862705 8.045131815869109 0 0 0 +452 1 3.5756141403862705 4.469517675482838 8.045131815869109 0 0 0 +453 1 5.363421210579405 3.5756141403862705 7.151228280772541 0 0 0 +454 1 6.257324745675973 4.469517675482838 7.151228280772541 0 0 0 +455 1 6.257324745675973 3.5756141403862705 8.045131815869109 0 0 0 +456 1 5.363421210579405 4.469517675482838 8.045131815869109 0 0 0 +457 1 7.151228280772541 3.5756141403862705 7.151228280772541 0 0 0 +458 1 8.045131815869109 4.469517675482838 7.151228280772541 0 0 0 +459 1 8.045131815869109 3.5756141403862705 8.045131815869109 0 0 0 +460 1 7.151228280772541 4.469517675482838 8.045131815869109 0 0 0 +461 1 0 5.363421210579405 7.151228280772541 0 0 0 +462 1 0.8939035350965676 6.257324745675973 7.151228280772541 0 0 0 +463 1 0.8939035350965676 5.363421210579405 8.045131815869109 0 0 0 +464 1 0 6.257324745675973 8.045131815869109 0 0 0 +465 1 1.7878070701931352 5.363421210579405 7.151228280772541 0 0 0 +466 1 2.6817106052897026 6.257324745675973 7.151228280772541 0 0 0 +467 1 2.6817106052897026 5.363421210579405 8.045131815869109 0 0 0 +468 1 1.7878070701931352 6.257324745675973 8.045131815869109 0 0 0 +469 1 3.5756141403862705 5.363421210579405 7.151228280772541 0 0 0 +470 1 4.469517675482838 6.257324745675973 7.151228280772541 0 0 0 +471 1 4.469517675482838 5.363421210579405 8.045131815869109 0 0 0 +472 1 3.5756141403862705 6.257324745675973 8.045131815869109 0 0 0 +473 1 5.363421210579405 5.363421210579405 7.151228280772541 0 0 0 +474 1 6.257324745675973 6.257324745675973 7.151228280772541 0 0 0 +475 1 6.257324745675973 5.363421210579405 8.045131815869109 0 0 0 +476 1 5.363421210579405 6.257324745675973 8.045131815869109 0 0 0 +477 1 7.151228280772541 5.363421210579405 7.151228280772541 0 0 0 +478 1 8.045131815869109 6.257324745675973 7.151228280772541 0 0 0 +479 1 8.045131815869109 5.363421210579405 8.045131815869109 0 0 0 +480 1 7.151228280772541 6.257324745675973 8.045131815869109 0 0 0 +481 1 0 7.151228280772541 7.151228280772541 0 0 0 +482 1 0.8939035350965676 8.045131815869109 7.151228280772541 0 0 0 +483 1 0.8939035350965676 7.151228280772541 8.045131815869109 0 0 0 +484 1 0 8.045131815869109 8.045131815869109 0 0 0 +485 1 1.7878070701931352 7.151228280772541 7.151228280772541 0 0 0 +486 1 2.6817106052897026 8.045131815869109 7.151228280772541 0 0 0 +487 1 2.6817106052897026 7.151228280772541 8.045131815869109 0 0 0 +488 1 1.7878070701931352 8.045131815869109 8.045131815869109 0 0 0 +489 1 3.5756141403862705 7.151228280772541 7.151228280772541 0 0 0 +490 1 4.469517675482838 8.045131815869109 7.151228280772541 0 0 0 +491 1 4.469517675482838 7.151228280772541 8.045131815869109 0 0 0 +492 1 3.5756141403862705 8.045131815869109 8.045131815869109 0 0 0 +493 1 5.363421210579405 7.151228280772541 7.151228280772541 0 0 0 +494 1 6.257324745675973 8.045131815869109 7.151228280772541 0 0 0 +495 1 6.257324745675973 7.151228280772541 8.045131815869109 0 0 0 +496 1 5.363421210579405 8.045131815869109 8.045131815869109 0 0 0 +497 1 7.151228280772541 7.151228280772541 7.151228280772541 0 0 0 +498 1 8.045131815869109 8.045131815869109 7.151228280772541 0 0 0 +499 1 8.045131815869109 7.151228280772541 8.045131815869109 0 0 0 +500 1 7.151228280772541 8.045131815869109 8.045131815869109 0 0 0 + +Velocities + +1 0 0 0 +2 0 0 0 +3 0 0 0 +4 0 0 0 +5 0 0 0 +6 0 0 0 +7 0 0 0 +8 0 0 0 +9 0 0 0 +10 0 0 0 +11 0 0 0 +12 0 0 0 +13 0 0 0 +14 0 0 0 +15 0 0 0 +16 0 0 0 +17 0 0 0 +18 0 0 0 +19 0 0 0 +20 0 0 0 +21 0 0 0 +22 0 0 0 +23 0 0 0 +24 0 0 0 +25 0 0 0 +26 0 0 0 +27 0 0 0 +28 0 0 0 +29 0 0 0 +30 0 0 0 +31 0 0 0 +32 0 0 0 +33 0 0 0 +34 0 0 0 +35 0 0 0 +36 0 0 0 +37 0 0 0 +38 0 0 0 +39 0 0 0 +40 0 0 0 +41 0 0 0 +42 0 0 0 +43 0 0 0 +44 0 0 0 +45 0 0 0 +46 0 0 0 +47 0 0 0 +48 0 0 0 +49 0 0 0 +50 0 0 0 +51 0 0 0 +52 0 0 0 +53 0 0 0 +54 0 0 0 +55 0 0 0 +56 0 0 0 +57 0 0 0 +58 0 0 0 +59 0 0 0 +60 0 0 0 +61 0 0 0 +62 0 0 0 +63 0 0 0 +64 0 0 0 +65 0 0 0 +66 0 0 0 +67 0 0 0 +68 0 0 0 +69 0 0 0 +70 0 0 0 +71 0 0 0 +72 0 0 0 +73 0 0 0 +74 0 0 0 +75 0 0 0 +76 0 0 0 +77 0 0 0 +78 0 0 0 +79 0 0 0 +80 0 0 0 +81 0 0 0 +82 0 0 0 +83 0 0 0 +84 0 0 0 +85 0 0 0 +86 0 0 0 +87 0 0 0 +88 0 0 0 +89 0 0 0 +90 0 0 0 +91 0 0 0 +92 0 0 0 +93 0 0 0 +94 0 0 0 +95 0 0 0 +96 0 0 0 +97 0 0 0 +98 0 0 0 +99 0 0 0 +100 0 0 0 +101 0 0 0 +102 0 0 0 +103 0 0 0 +104 0 0 0 +105 0 0 0 +106 0 0 0 +107 0 0 0 +108 0 0 0 +109 0 0 0 +110 0 0 0 +111 0 0 0 +112 0 0 0 +113 0 0 0 +114 0 0 0 +115 0 0 0 +116 0 0 0 +117 0 0 0 +118 0 0 0 +119 0 0 0 +120 0 0 0 +121 0 0 0 +122 0 0 0 +123 0 0 0 +124 0 0 0 +125 0 0 0 +126 0 0 0 +127 0 0 0 +128 0 0 0 +129 0 0 0 +130 0 0 0 +131 0 0 0 +132 0 0 0 +133 0 0 0 +134 0 0 0 +135 0 0 0 +136 0 0 0 +137 0 0 0 +138 0 0 0 +139 0 0 0 +140 0 0 0 +141 0 0 0 +142 0 0 0 +143 0 0 0 +144 0 0 0 +145 0 0 0 +146 0 0 0 +147 0 0 0 +148 0 0 0 +149 0 0 0 +150 0 0 0 +151 0 0 0 +152 0 0 0 +153 0 0 0 +154 0 0 0 +155 0 0 0 +156 0 0 0 +157 0 0 0 +158 0 0 0 +159 0 0 0 +160 0 0 0 +161 0 0 0 +162 0 0 0 +163 0 0 0 +164 0 0 0 +165 0 0 0 +166 0 0 0 +167 0 0 0 +168 0 0 0 +169 0 0 0 +170 0 0 0 +171 0 0 0 +172 0 0 0 +173 0 0 0 +174 0 0 0 +175 0 0 0 +176 0 0 0 +177 0 0 0 +178 0 0 0 +179 0 0 0 +180 0 0 0 +181 0 0 0 +182 0 0 0 +183 0 0 0 +184 0 0 0 +185 0 0 0 +186 0 0 0 +187 0 0 0 +188 0 0 0 +189 0 0 0 +190 0 0 0 +191 0 0 0 +192 0 0 0 +193 0 0 0 +194 0 0 0 +195 0 0 0 +196 0 0 0 +197 0 0 0 +198 0 0 0 +199 0 0 0 +200 0 0 0 +201 0 0 0 +202 0 0 0 +203 0 0 0 +204 0 0 0 +205 0 0 0 +206 0 0 0 +207 0 0 0 +208 0 0 0 +209 0 0 0 +210 0 0 0 +211 0 0 0 +212 0 0 0 +213 0 0 0 +214 0 0 0 +215 0 0 0 +216 0 0 0 +217 0 0 0 +218 0 0 0 +219 0 0 0 +220 0 0 0 +221 0 0 0 +222 0 0 0 +223 0 0 0 +224 0 0 0 +225 0 0 0 +226 0 0 0 +227 0 0 0 +228 0 0 0 +229 0 0 0 +230 0 0 0 +231 0 0 0 +232 0 0 0 +233 0 0 0 +234 0 0 0 +235 0 0 0 +236 0 0 0 +237 0 0 0 +238 0 0 0 +239 0 0 0 +240 0 0 0 +241 0 0 0 +242 0 0 0 +243 0 0 0 +244 0 0 0 +245 0 0 0 +246 0 0 0 +247 0 0 0 +248 0 0 0 +249 0 0 0 +250 0 0 0 +251 0 0 0 +252 0 0 0 +253 0 0 0 +254 0 0 0 +255 0 0 0 +256 0 0 0 +257 0 0 0 +258 0 0 0 +259 0 0 0 +260 0 0 0 +261 0 0 0 +262 0 0 0 +263 0 0 0 +264 0 0 0 +265 0 0 0 +266 0 0 0 +267 0 0 0 +268 0 0 0 +269 0 0 0 +270 0 0 0 +271 0 0 0 +272 0 0 0 +273 0 0 0 +274 0 0 0 +275 0 0 0 +276 0 0 0 +277 0 0 0 +278 0 0 0 +279 0 0 0 +280 0 0 0 +281 0 0 0 +282 0 0 0 +283 0 0 0 +284 0 0 0 +285 0 0 0 +286 0 0 0 +287 0 0 0 +288 0 0 0 +289 0 0 0 +290 0 0 0 +291 0 0 0 +292 0 0 0 +293 0 0 0 +294 0 0 0 +295 0 0 0 +296 0 0 0 +297 0 0 0 +298 0 0 0 +299 0 0 0 +300 0 0 0 +301 0 0 0 +302 0 0 0 +303 0 0 0 +304 0 0 0 +305 0 0 0 +306 0 0 0 +307 0 0 0 +308 0 0 0 +309 0 0 0 +310 0 0 0 +311 0 0 0 +312 0 0 0 +313 0 0 0 +314 0 0 0 +315 0 0 0 +316 0 0 0 +317 0 0 0 +318 0 0 0 +319 0 0 0 +320 0 0 0 +321 0 0 0 +322 0 0 0 +323 0 0 0 +324 0 0 0 +325 0 0 0 +326 0 0 0 +327 0 0 0 +328 0 0 0 +329 0 0 0 +330 0 0 0 +331 0 0 0 +332 0 0 0 +333 0 0 0 +334 0 0 0 +335 0 0 0 +336 0 0 0 +337 0 0 0 +338 0 0 0 +339 0 0 0 +340 0 0 0 +341 0 0 0 +342 0 0 0 +343 0 0 0 +344 0 0 0 +345 0 0 0 +346 0 0 0 +347 0 0 0 +348 0 0 0 +349 0 0 0 +350 0 0 0 +351 0 0 0 +352 0 0 0 +353 0 0 0 +354 0 0 0 +355 0 0 0 +356 0 0 0 +357 0 0 0 +358 0 0 0 +359 0 0 0 +360 0 0 0 +361 0 0 0 +362 0 0 0 +363 0 0 0 +364 0 0 0 +365 0 0 0 +366 0 0 0 +367 0 0 0 +368 0 0 0 +369 0 0 0 +370 0 0 0 +371 0 0 0 +372 0 0 0 +373 0 0 0 +374 0 0 0 +375 0 0 0 +376 0 0 0 +377 0 0 0 +378 0 0 0 +379 0 0 0 +380 0 0 0 +381 0 0 0 +382 0 0 0 +383 0 0 0 +384 0 0 0 +385 0 0 0 +386 0 0 0 +387 0 0 0 +388 0 0 0 +389 0 0 0 +390 0 0 0 +391 0 0 0 +392 0 0 0 +393 0 0 0 +394 0 0 0 +395 0 0 0 +396 0 0 0 +397 0 0 0 +398 0 0 0 +399 0 0 0 +400 0 0 0 +401 0 0 0 +402 0 0 0 +403 0 0 0 +404 0 0 0 +405 0 0 0 +406 0 0 0 +407 0 0 0 +408 0 0 0 +409 0 0 0 +410 0 0 0 +411 0 0 0 +412 0 0 0 +413 0 0 0 +414 0 0 0 +415 0 0 0 +416 0 0 0 +417 0 0 0 +418 0 0 0 +419 0 0 0 +420 0 0 0 +421 0 0 0 +422 0 0 0 +423 0 0 0 +424 0 0 0 +425 0 0 0 +426 0 0 0 +427 0 0 0 +428 0 0 0 +429 0 0 0 +430 0 0 0 +431 0 0 0 +432 0 0 0 +433 0 0 0 +434 0 0 0 +435 0 0 0 +436 0 0 0 +437 0 0 0 +438 0 0 0 +439 0 0 0 +440 0 0 0 +441 0 0 0 +442 0 0 0 +443 0 0 0 +444 0 0 0 +445 0 0 0 +446 0 0 0 +447 0 0 0 +448 0 0 0 +449 0 0 0 +450 0 0 0 +451 0 0 0 +452 0 0 0 +453 0 0 0 +454 0 0 0 +455 0 0 0 +456 0 0 0 +457 0 0 0 +458 0 0 0 +459 0 0 0 +460 0 0 0 +461 0 0 0 +462 0 0 0 +463 0 0 0 +464 0 0 0 +465 0 0 0 +466 0 0 0 +467 0 0 0 +468 0 0 0 +469 0 0 0 +470 0 0 0 +471 0 0 0 +472 0 0 0 +473 0 0 0 +474 0 0 0 +475 0 0 0 +476 0 0 0 +477 0 0 0 +478 0 0 0 +479 0 0 0 +480 0 0 0 +481 0 0 0 +482 0 0 0 +483 0 0 0 +484 0 0 0 +485 0 0 0 +486 0 0 0 +487 0 0 0 +488 0 0 0 +489 0 0 0 +490 0 0 0 +491 0 0 0 +492 0 0 0 +493 0 0 0 +494 0 0 0 +495 0 0 0 +496 0 0 0 +497 0 0 0 +498 0 0 0 +499 0 0 0 +500 0 0 0 diff --git a/examples/mdi/data.series.0.8 b/examples/mdi/data.series.0.8 new file mode 100644 index 0000000000..38fb5dd47e --- /dev/null +++ b/examples/mdi/data.series.0.8 @@ -0,0 +1,1018 @@ +LAMMPS data file via write_data, version 2 Jun 2022, timestep = 0 + +500 atoms +1 atom types + +0 8.549879733383484 xlo xhi +0 8.549879733383484 ylo yhi +0 8.549879733383484 zlo zhi + +Masses + +1 1 + +Atoms # atomic + +1 1 0 0 0 0 0 0 +2 1 0.8549879733383484 0.8549879733383484 0 0 0 0 +3 1 0.8549879733383484 0 0.8549879733383484 0 0 0 +4 1 0 0.8549879733383484 0.8549879733383484 0 0 0 +5 1 1.7099759466766968 0 0 0 0 0 +6 1 2.564963920015045 0.8549879733383484 0 0 0 0 +7 1 2.564963920015045 0 0.8549879733383484 0 0 0 +8 1 1.7099759466766968 0.8549879733383484 0.8549879733383484 0 0 0 +9 1 3.4199518933533937 0 0 0 0 0 +10 1 4.274939866691742 0.8549879733383484 0 0 0 0 +11 1 4.274939866691742 0 0.8549879733383484 0 0 0 +12 1 3.4199518933533937 0.8549879733383484 0.8549879733383484 0 0 0 +13 1 5.12992784003009 0 0 0 0 0 +14 1 5.984915813368439 0.8549879733383484 0 0 0 0 +15 1 5.984915813368439 0 0.8549879733383484 0 0 0 +16 1 5.12992784003009 0.8549879733383484 0.8549879733383484 0 0 0 +17 1 6.839903786706787 0 0 0 0 0 +18 1 7.694891760045135 0.8549879733383484 0 0 0 0 +19 1 7.694891760045135 0 0.8549879733383484 0 0 0 +20 1 6.839903786706787 0.8549879733383484 0.8549879733383484 0 0 0 +21 1 0 1.7099759466766968 0 0 0 0 +22 1 0.8549879733383484 2.564963920015045 0 0 0 0 +23 1 0.8549879733383484 1.7099759466766968 0.8549879733383484 0 0 0 +24 1 0 2.564963920015045 0.8549879733383484 0 0 0 +25 1 1.7099759466766968 1.7099759466766968 0 0 0 0 +26 1 2.564963920015045 2.564963920015045 0 0 0 0 +27 1 2.564963920015045 1.7099759466766968 0.8549879733383484 0 0 0 +28 1 1.7099759466766968 2.564963920015045 0.8549879733383484 0 0 0 +29 1 3.4199518933533937 1.7099759466766968 0 0 0 0 +30 1 4.274939866691742 2.564963920015045 0 0 0 0 +31 1 4.274939866691742 1.7099759466766968 0.8549879733383484 0 0 0 +32 1 3.4199518933533937 2.564963920015045 0.8549879733383484 0 0 0 +33 1 5.12992784003009 1.7099759466766968 0 0 0 0 +34 1 5.984915813368439 2.564963920015045 0 0 0 0 +35 1 5.984915813368439 1.7099759466766968 0.8549879733383484 0 0 0 +36 1 5.12992784003009 2.564963920015045 0.8549879733383484 0 0 0 +37 1 6.839903786706787 1.7099759466766968 0 0 0 0 +38 1 7.694891760045135 2.564963920015045 0 0 0 0 +39 1 7.694891760045135 1.7099759466766968 0.8549879733383484 0 0 0 +40 1 6.839903786706787 2.564963920015045 0.8549879733383484 0 0 0 +41 1 0 3.4199518933533937 0 0 0 0 +42 1 0.8549879733383484 4.274939866691742 0 0 0 0 +43 1 0.8549879733383484 3.4199518933533937 0.8549879733383484 0 0 0 +44 1 0 4.274939866691742 0.8549879733383484 0 0 0 +45 1 1.7099759466766968 3.4199518933533937 0 0 0 0 +46 1 2.564963920015045 4.274939866691742 0 0 0 0 +47 1 2.564963920015045 3.4199518933533937 0.8549879733383484 0 0 0 +48 1 1.7099759466766968 4.274939866691742 0.8549879733383484 0 0 0 +49 1 3.4199518933533937 3.4199518933533937 0 0 0 0 +50 1 4.274939866691742 4.274939866691742 0 0 0 0 +51 1 4.274939866691742 3.4199518933533937 0.8549879733383484 0 0 0 +52 1 3.4199518933533937 4.274939866691742 0.8549879733383484 0 0 0 +53 1 5.12992784003009 3.4199518933533937 0 0 0 0 +54 1 5.984915813368439 4.274939866691742 0 0 0 0 +55 1 5.984915813368439 3.4199518933533937 0.8549879733383484 0 0 0 +56 1 5.12992784003009 4.274939866691742 0.8549879733383484 0 0 0 +57 1 6.839903786706787 3.4199518933533937 0 0 0 0 +58 1 7.694891760045135 4.274939866691742 0 0 0 0 +59 1 7.694891760045135 3.4199518933533937 0.8549879733383484 0 0 0 +60 1 6.839903786706787 4.274939866691742 0.8549879733383484 0 0 0 +61 1 0 5.12992784003009 0 0 0 0 +62 1 0.8549879733383484 5.984915813368439 0 0 0 0 +63 1 0.8549879733383484 5.12992784003009 0.8549879733383484 0 0 0 +64 1 0 5.984915813368439 0.8549879733383484 0 0 0 +65 1 1.7099759466766968 5.12992784003009 0 0 0 0 +66 1 2.564963920015045 5.984915813368439 0 0 0 0 +67 1 2.564963920015045 5.12992784003009 0.8549879733383484 0 0 0 +68 1 1.7099759466766968 5.984915813368439 0.8549879733383484 0 0 0 +69 1 3.4199518933533937 5.12992784003009 0 0 0 0 +70 1 4.274939866691742 5.984915813368439 0 0 0 0 +71 1 4.274939866691742 5.12992784003009 0.8549879733383484 0 0 0 +72 1 3.4199518933533937 5.984915813368439 0.8549879733383484 0 0 0 +73 1 5.12992784003009 5.12992784003009 0 0 0 0 +74 1 5.984915813368439 5.984915813368439 0 0 0 0 +75 1 5.984915813368439 5.12992784003009 0.8549879733383484 0 0 0 +76 1 5.12992784003009 5.984915813368439 0.8549879733383484 0 0 0 +77 1 6.839903786706787 5.12992784003009 0 0 0 0 +78 1 7.694891760045135 5.984915813368439 0 0 0 0 +79 1 7.694891760045135 5.12992784003009 0.8549879733383484 0 0 0 +80 1 6.839903786706787 5.984915813368439 0.8549879733383484 0 0 0 +81 1 0 6.839903786706787 0 0 0 0 +82 1 0.8549879733383484 7.694891760045135 0 0 0 0 +83 1 0.8549879733383484 6.839903786706787 0.8549879733383484 0 0 0 +84 1 0 7.694891760045135 0.8549879733383484 0 0 0 +85 1 1.7099759466766968 6.839903786706787 0 0 0 0 +86 1 2.564963920015045 7.694891760045135 0 0 0 0 +87 1 2.564963920015045 6.839903786706787 0.8549879733383484 0 0 0 +88 1 1.7099759466766968 7.694891760045135 0.8549879733383484 0 0 0 +89 1 3.4199518933533937 6.839903786706787 0 0 0 0 +90 1 4.274939866691742 7.694891760045135 0 0 0 0 +91 1 4.274939866691742 6.839903786706787 0.8549879733383484 0 0 0 +92 1 3.4199518933533937 7.694891760045135 0.8549879733383484 0 0 0 +93 1 5.12992784003009 6.839903786706787 0 0 0 0 +94 1 5.984915813368439 7.694891760045135 0 0 0 0 +95 1 5.984915813368439 6.839903786706787 0.8549879733383484 0 0 0 +96 1 5.12992784003009 7.694891760045135 0.8549879733383484 0 0 0 +97 1 6.839903786706787 6.839903786706787 0 0 0 0 +98 1 7.694891760045135 7.694891760045135 0 0 0 0 +99 1 7.694891760045135 6.839903786706787 0.8549879733383484 0 0 0 +100 1 6.839903786706787 7.694891760045135 0.8549879733383484 0 0 0 +101 1 0 0 1.7099759466766968 0 0 0 +102 1 0.8549879733383484 0.8549879733383484 1.7099759466766968 0 0 0 +103 1 0.8549879733383484 0 2.564963920015045 0 0 0 +104 1 0 0.8549879733383484 2.564963920015045 0 0 0 +105 1 1.7099759466766968 0 1.7099759466766968 0 0 0 +106 1 2.564963920015045 0.8549879733383484 1.7099759466766968 0 0 0 +107 1 2.564963920015045 0 2.564963920015045 0 0 0 +108 1 1.7099759466766968 0.8549879733383484 2.564963920015045 0 0 0 +109 1 3.4199518933533937 0 1.7099759466766968 0 0 0 +110 1 4.274939866691742 0.8549879733383484 1.7099759466766968 0 0 0 +111 1 4.274939866691742 0 2.564963920015045 0 0 0 +112 1 3.4199518933533937 0.8549879733383484 2.564963920015045 0 0 0 +113 1 5.12992784003009 0 1.7099759466766968 0 0 0 +114 1 5.984915813368439 0.8549879733383484 1.7099759466766968 0 0 0 +115 1 5.984915813368439 0 2.564963920015045 0 0 0 +116 1 5.12992784003009 0.8549879733383484 2.564963920015045 0 0 0 +117 1 6.839903786706787 0 1.7099759466766968 0 0 0 +118 1 7.694891760045135 0.8549879733383484 1.7099759466766968 0 0 0 +119 1 7.694891760045135 0 2.564963920015045 0 0 0 +120 1 6.839903786706787 0.8549879733383484 2.564963920015045 0 0 0 +121 1 0 1.7099759466766968 1.7099759466766968 0 0 0 +122 1 0.8549879733383484 2.564963920015045 1.7099759466766968 0 0 0 +123 1 0.8549879733383484 1.7099759466766968 2.564963920015045 0 0 0 +124 1 0 2.564963920015045 2.564963920015045 0 0 0 +125 1 1.7099759466766968 1.7099759466766968 1.7099759466766968 0 0 0 +126 1 2.564963920015045 2.564963920015045 1.7099759466766968 0 0 0 +127 1 2.564963920015045 1.7099759466766968 2.564963920015045 0 0 0 +128 1 1.7099759466766968 2.564963920015045 2.564963920015045 0 0 0 +129 1 3.4199518933533937 1.7099759466766968 1.7099759466766968 0 0 0 +130 1 4.274939866691742 2.564963920015045 1.7099759466766968 0 0 0 +131 1 4.274939866691742 1.7099759466766968 2.564963920015045 0 0 0 +132 1 3.4199518933533937 2.564963920015045 2.564963920015045 0 0 0 +133 1 5.12992784003009 1.7099759466766968 1.7099759466766968 0 0 0 +134 1 5.984915813368439 2.564963920015045 1.7099759466766968 0 0 0 +135 1 5.984915813368439 1.7099759466766968 2.564963920015045 0 0 0 +136 1 5.12992784003009 2.564963920015045 2.564963920015045 0 0 0 +137 1 6.839903786706787 1.7099759466766968 1.7099759466766968 0 0 0 +138 1 7.694891760045135 2.564963920015045 1.7099759466766968 0 0 0 +139 1 7.694891760045135 1.7099759466766968 2.564963920015045 0 0 0 +140 1 6.839903786706787 2.564963920015045 2.564963920015045 0 0 0 +141 1 0 3.4199518933533937 1.7099759466766968 0 0 0 +142 1 0.8549879733383484 4.274939866691742 1.7099759466766968 0 0 0 +143 1 0.8549879733383484 3.4199518933533937 2.564963920015045 0 0 0 +144 1 0 4.274939866691742 2.564963920015045 0 0 0 +145 1 1.7099759466766968 3.4199518933533937 1.7099759466766968 0 0 0 +146 1 2.564963920015045 4.274939866691742 1.7099759466766968 0 0 0 +147 1 2.564963920015045 3.4199518933533937 2.564963920015045 0 0 0 +148 1 1.7099759466766968 4.274939866691742 2.564963920015045 0 0 0 +149 1 3.4199518933533937 3.4199518933533937 1.7099759466766968 0 0 0 +150 1 4.274939866691742 4.274939866691742 1.7099759466766968 0 0 0 +151 1 4.274939866691742 3.4199518933533937 2.564963920015045 0 0 0 +152 1 3.4199518933533937 4.274939866691742 2.564963920015045 0 0 0 +153 1 5.12992784003009 3.4199518933533937 1.7099759466766968 0 0 0 +154 1 5.984915813368439 4.274939866691742 1.7099759466766968 0 0 0 +155 1 5.984915813368439 3.4199518933533937 2.564963920015045 0 0 0 +156 1 5.12992784003009 4.274939866691742 2.564963920015045 0 0 0 +157 1 6.839903786706787 3.4199518933533937 1.7099759466766968 0 0 0 +158 1 7.694891760045135 4.274939866691742 1.7099759466766968 0 0 0 +159 1 7.694891760045135 3.4199518933533937 2.564963920015045 0 0 0 +160 1 6.839903786706787 4.274939866691742 2.564963920015045 0 0 0 +161 1 0 5.12992784003009 1.7099759466766968 0 0 0 +162 1 0.8549879733383484 5.984915813368439 1.7099759466766968 0 0 0 +163 1 0.8549879733383484 5.12992784003009 2.564963920015045 0 0 0 +164 1 0 5.984915813368439 2.564963920015045 0 0 0 +165 1 1.7099759466766968 5.12992784003009 1.7099759466766968 0 0 0 +166 1 2.564963920015045 5.984915813368439 1.7099759466766968 0 0 0 +167 1 2.564963920015045 5.12992784003009 2.564963920015045 0 0 0 +168 1 1.7099759466766968 5.984915813368439 2.564963920015045 0 0 0 +169 1 3.4199518933533937 5.12992784003009 1.7099759466766968 0 0 0 +170 1 4.274939866691742 5.984915813368439 1.7099759466766968 0 0 0 +171 1 4.274939866691742 5.12992784003009 2.564963920015045 0 0 0 +172 1 3.4199518933533937 5.984915813368439 2.564963920015045 0 0 0 +173 1 5.12992784003009 5.12992784003009 1.7099759466766968 0 0 0 +174 1 5.984915813368439 5.984915813368439 1.7099759466766968 0 0 0 +175 1 5.984915813368439 5.12992784003009 2.564963920015045 0 0 0 +176 1 5.12992784003009 5.984915813368439 2.564963920015045 0 0 0 +177 1 6.839903786706787 5.12992784003009 1.7099759466766968 0 0 0 +178 1 7.694891760045135 5.984915813368439 1.7099759466766968 0 0 0 +179 1 7.694891760045135 5.12992784003009 2.564963920015045 0 0 0 +180 1 6.839903786706787 5.984915813368439 2.564963920015045 0 0 0 +181 1 0 6.839903786706787 1.7099759466766968 0 0 0 +182 1 0.8549879733383484 7.694891760045135 1.7099759466766968 0 0 0 +183 1 0.8549879733383484 6.839903786706787 2.564963920015045 0 0 0 +184 1 0 7.694891760045135 2.564963920015045 0 0 0 +185 1 1.7099759466766968 6.839903786706787 1.7099759466766968 0 0 0 +186 1 2.564963920015045 7.694891760045135 1.7099759466766968 0 0 0 +187 1 2.564963920015045 6.839903786706787 2.564963920015045 0 0 0 +188 1 1.7099759466766968 7.694891760045135 2.564963920015045 0 0 0 +189 1 3.4199518933533937 6.839903786706787 1.7099759466766968 0 0 0 +190 1 4.274939866691742 7.694891760045135 1.7099759466766968 0 0 0 +191 1 4.274939866691742 6.839903786706787 2.564963920015045 0 0 0 +192 1 3.4199518933533937 7.694891760045135 2.564963920015045 0 0 0 +193 1 5.12992784003009 6.839903786706787 1.7099759466766968 0 0 0 +194 1 5.984915813368439 7.694891760045135 1.7099759466766968 0 0 0 +195 1 5.984915813368439 6.839903786706787 2.564963920015045 0 0 0 +196 1 5.12992784003009 7.694891760045135 2.564963920015045 0 0 0 +197 1 6.839903786706787 6.839903786706787 1.7099759466766968 0 0 0 +198 1 7.694891760045135 7.694891760045135 1.7099759466766968 0 0 0 +199 1 7.694891760045135 6.839903786706787 2.564963920015045 0 0 0 +200 1 6.839903786706787 7.694891760045135 2.564963920015045 0 0 0 +201 1 0 0 3.4199518933533937 0 0 0 +202 1 0.8549879733383484 0.8549879733383484 3.4199518933533937 0 0 0 +203 1 0.8549879733383484 0 4.274939866691742 0 0 0 +204 1 0 0.8549879733383484 4.274939866691742 0 0 0 +205 1 1.7099759466766968 0 3.4199518933533937 0 0 0 +206 1 2.564963920015045 0.8549879733383484 3.4199518933533937 0 0 0 +207 1 2.564963920015045 0 4.274939866691742 0 0 0 +208 1 1.7099759466766968 0.8549879733383484 4.274939866691742 0 0 0 +209 1 3.4199518933533937 0 3.4199518933533937 0 0 0 +210 1 4.274939866691742 0.8549879733383484 3.4199518933533937 0 0 0 +211 1 4.274939866691742 0 4.274939866691742 0 0 0 +212 1 3.4199518933533937 0.8549879733383484 4.274939866691742 0 0 0 +213 1 5.12992784003009 0 3.4199518933533937 0 0 0 +214 1 5.984915813368439 0.8549879733383484 3.4199518933533937 0 0 0 +215 1 5.984915813368439 0 4.274939866691742 0 0 0 +216 1 5.12992784003009 0.8549879733383484 4.274939866691742 0 0 0 +217 1 6.839903786706787 0 3.4199518933533937 0 0 0 +218 1 7.694891760045135 0.8549879733383484 3.4199518933533937 0 0 0 +219 1 7.694891760045135 0 4.274939866691742 0 0 0 +220 1 6.839903786706787 0.8549879733383484 4.274939866691742 0 0 0 +221 1 0 1.7099759466766968 3.4199518933533937 0 0 0 +222 1 0.8549879733383484 2.564963920015045 3.4199518933533937 0 0 0 +223 1 0.8549879733383484 1.7099759466766968 4.274939866691742 0 0 0 +224 1 0 2.564963920015045 4.274939866691742 0 0 0 +225 1 1.7099759466766968 1.7099759466766968 3.4199518933533937 0 0 0 +226 1 2.564963920015045 2.564963920015045 3.4199518933533937 0 0 0 +227 1 2.564963920015045 1.7099759466766968 4.274939866691742 0 0 0 +228 1 1.7099759466766968 2.564963920015045 4.274939866691742 0 0 0 +229 1 3.4199518933533937 1.7099759466766968 3.4199518933533937 0 0 0 +230 1 4.274939866691742 2.564963920015045 3.4199518933533937 0 0 0 +231 1 4.274939866691742 1.7099759466766968 4.274939866691742 0 0 0 +232 1 3.4199518933533937 2.564963920015045 4.274939866691742 0 0 0 +233 1 5.12992784003009 1.7099759466766968 3.4199518933533937 0 0 0 +234 1 5.984915813368439 2.564963920015045 3.4199518933533937 0 0 0 +235 1 5.984915813368439 1.7099759466766968 4.274939866691742 0 0 0 +236 1 5.12992784003009 2.564963920015045 4.274939866691742 0 0 0 +237 1 6.839903786706787 1.7099759466766968 3.4199518933533937 0 0 0 +238 1 7.694891760045135 2.564963920015045 3.4199518933533937 0 0 0 +239 1 7.694891760045135 1.7099759466766968 4.274939866691742 0 0 0 +240 1 6.839903786706787 2.564963920015045 4.274939866691742 0 0 0 +241 1 0 3.4199518933533937 3.4199518933533937 0 0 0 +242 1 0.8549879733383484 4.274939866691742 3.4199518933533937 0 0 0 +243 1 0.8549879733383484 3.4199518933533937 4.274939866691742 0 0 0 +244 1 0 4.274939866691742 4.274939866691742 0 0 0 +245 1 1.7099759466766968 3.4199518933533937 3.4199518933533937 0 0 0 +246 1 2.564963920015045 4.274939866691742 3.4199518933533937 0 0 0 +247 1 2.564963920015045 3.4199518933533937 4.274939866691742 0 0 0 +248 1 1.7099759466766968 4.274939866691742 4.274939866691742 0 0 0 +249 1 3.4199518933533937 3.4199518933533937 3.4199518933533937 0 0 0 +250 1 4.274939866691742 4.274939866691742 3.4199518933533937 0 0 0 +251 1 4.274939866691742 3.4199518933533937 4.274939866691742 0 0 0 +252 1 3.4199518933533937 4.274939866691742 4.274939866691742 0 0 0 +253 1 5.12992784003009 3.4199518933533937 3.4199518933533937 0 0 0 +254 1 5.984915813368439 4.274939866691742 3.4199518933533937 0 0 0 +255 1 5.984915813368439 3.4199518933533937 4.274939866691742 0 0 0 +256 1 5.12992784003009 4.274939866691742 4.274939866691742 0 0 0 +257 1 6.839903786706787 3.4199518933533937 3.4199518933533937 0 0 0 +258 1 7.694891760045135 4.274939866691742 3.4199518933533937 0 0 0 +259 1 7.694891760045135 3.4199518933533937 4.274939866691742 0 0 0 +260 1 6.839903786706787 4.274939866691742 4.274939866691742 0 0 0 +261 1 0 5.12992784003009 3.4199518933533937 0 0 0 +262 1 0.8549879733383484 5.984915813368439 3.4199518933533937 0 0 0 +263 1 0.8549879733383484 5.12992784003009 4.274939866691742 0 0 0 +264 1 0 5.984915813368439 4.274939866691742 0 0 0 +265 1 1.7099759466766968 5.12992784003009 3.4199518933533937 0 0 0 +266 1 2.564963920015045 5.984915813368439 3.4199518933533937 0 0 0 +267 1 2.564963920015045 5.12992784003009 4.274939866691742 0 0 0 +268 1 1.7099759466766968 5.984915813368439 4.274939866691742 0 0 0 +269 1 3.4199518933533937 5.12992784003009 3.4199518933533937 0 0 0 +270 1 4.274939866691742 5.984915813368439 3.4199518933533937 0 0 0 +271 1 4.274939866691742 5.12992784003009 4.274939866691742 0 0 0 +272 1 3.4199518933533937 5.984915813368439 4.274939866691742 0 0 0 +273 1 5.12992784003009 5.12992784003009 3.4199518933533937 0 0 0 +274 1 5.984915813368439 5.984915813368439 3.4199518933533937 0 0 0 +275 1 5.984915813368439 5.12992784003009 4.274939866691742 0 0 0 +276 1 5.12992784003009 5.984915813368439 4.274939866691742 0 0 0 +277 1 6.839903786706787 5.12992784003009 3.4199518933533937 0 0 0 +278 1 7.694891760045135 5.984915813368439 3.4199518933533937 0 0 0 +279 1 7.694891760045135 5.12992784003009 4.274939866691742 0 0 0 +280 1 6.839903786706787 5.984915813368439 4.274939866691742 0 0 0 +281 1 0 6.839903786706787 3.4199518933533937 0 0 0 +282 1 0.8549879733383484 7.694891760045135 3.4199518933533937 0 0 0 +283 1 0.8549879733383484 6.839903786706787 4.274939866691742 0 0 0 +284 1 0 7.694891760045135 4.274939866691742 0 0 0 +285 1 1.7099759466766968 6.839903786706787 3.4199518933533937 0 0 0 +286 1 2.564963920015045 7.694891760045135 3.4199518933533937 0 0 0 +287 1 2.564963920015045 6.839903786706787 4.274939866691742 0 0 0 +288 1 1.7099759466766968 7.694891760045135 4.274939866691742 0 0 0 +289 1 3.4199518933533937 6.839903786706787 3.4199518933533937 0 0 0 +290 1 4.274939866691742 7.694891760045135 3.4199518933533937 0 0 0 +291 1 4.274939866691742 6.839903786706787 4.274939866691742 0 0 0 +292 1 3.4199518933533937 7.694891760045135 4.274939866691742 0 0 0 +293 1 5.12992784003009 6.839903786706787 3.4199518933533937 0 0 0 +294 1 5.984915813368439 7.694891760045135 3.4199518933533937 0 0 0 +295 1 5.984915813368439 6.839903786706787 4.274939866691742 0 0 0 +296 1 5.12992784003009 7.694891760045135 4.274939866691742 0 0 0 +297 1 6.839903786706787 6.839903786706787 3.4199518933533937 0 0 0 +298 1 7.694891760045135 7.694891760045135 3.4199518933533937 0 0 0 +299 1 7.694891760045135 6.839903786706787 4.274939866691742 0 0 0 +300 1 6.839903786706787 7.694891760045135 4.274939866691742 0 0 0 +301 1 0 0 5.12992784003009 0 0 0 +302 1 0.8549879733383484 0.8549879733383484 5.12992784003009 0 0 0 +303 1 0.8549879733383484 0 5.984915813368439 0 0 0 +304 1 0 0.8549879733383484 5.984915813368439 0 0 0 +305 1 1.7099759466766968 0 5.12992784003009 0 0 0 +306 1 2.564963920015045 0.8549879733383484 5.12992784003009 0 0 0 +307 1 2.564963920015045 0 5.984915813368439 0 0 0 +308 1 1.7099759466766968 0.8549879733383484 5.984915813368439 0 0 0 +309 1 3.4199518933533937 0 5.12992784003009 0 0 0 +310 1 4.274939866691742 0.8549879733383484 5.12992784003009 0 0 0 +311 1 4.274939866691742 0 5.984915813368439 0 0 0 +312 1 3.4199518933533937 0.8549879733383484 5.984915813368439 0 0 0 +313 1 5.12992784003009 0 5.12992784003009 0 0 0 +314 1 5.984915813368439 0.8549879733383484 5.12992784003009 0 0 0 +315 1 5.984915813368439 0 5.984915813368439 0 0 0 +316 1 5.12992784003009 0.8549879733383484 5.984915813368439 0 0 0 +317 1 6.839903786706787 0 5.12992784003009 0 0 0 +318 1 7.694891760045135 0.8549879733383484 5.12992784003009 0 0 0 +319 1 7.694891760045135 0 5.984915813368439 0 0 0 +320 1 6.839903786706787 0.8549879733383484 5.984915813368439 0 0 0 +321 1 0 1.7099759466766968 5.12992784003009 0 0 0 +322 1 0.8549879733383484 2.564963920015045 5.12992784003009 0 0 0 +323 1 0.8549879733383484 1.7099759466766968 5.984915813368439 0 0 0 +324 1 0 2.564963920015045 5.984915813368439 0 0 0 +325 1 1.7099759466766968 1.7099759466766968 5.12992784003009 0 0 0 +326 1 2.564963920015045 2.564963920015045 5.12992784003009 0 0 0 +327 1 2.564963920015045 1.7099759466766968 5.984915813368439 0 0 0 +328 1 1.7099759466766968 2.564963920015045 5.984915813368439 0 0 0 +329 1 3.4199518933533937 1.7099759466766968 5.12992784003009 0 0 0 +330 1 4.274939866691742 2.564963920015045 5.12992784003009 0 0 0 +331 1 4.274939866691742 1.7099759466766968 5.984915813368439 0 0 0 +332 1 3.4199518933533937 2.564963920015045 5.984915813368439 0 0 0 +333 1 5.12992784003009 1.7099759466766968 5.12992784003009 0 0 0 +334 1 5.984915813368439 2.564963920015045 5.12992784003009 0 0 0 +335 1 5.984915813368439 1.7099759466766968 5.984915813368439 0 0 0 +336 1 5.12992784003009 2.564963920015045 5.984915813368439 0 0 0 +337 1 6.839903786706787 1.7099759466766968 5.12992784003009 0 0 0 +338 1 7.694891760045135 2.564963920015045 5.12992784003009 0 0 0 +339 1 7.694891760045135 1.7099759466766968 5.984915813368439 0 0 0 +340 1 6.839903786706787 2.564963920015045 5.984915813368439 0 0 0 +341 1 0 3.4199518933533937 5.12992784003009 0 0 0 +342 1 0.8549879733383484 4.274939866691742 5.12992784003009 0 0 0 +343 1 0.8549879733383484 3.4199518933533937 5.984915813368439 0 0 0 +344 1 0 4.274939866691742 5.984915813368439 0 0 0 +345 1 1.7099759466766968 3.4199518933533937 5.12992784003009 0 0 0 +346 1 2.564963920015045 4.274939866691742 5.12992784003009 0 0 0 +347 1 2.564963920015045 3.4199518933533937 5.984915813368439 0 0 0 +348 1 1.7099759466766968 4.274939866691742 5.984915813368439 0 0 0 +349 1 3.4199518933533937 3.4199518933533937 5.12992784003009 0 0 0 +350 1 4.274939866691742 4.274939866691742 5.12992784003009 0 0 0 +351 1 4.274939866691742 3.4199518933533937 5.984915813368439 0 0 0 +352 1 3.4199518933533937 4.274939866691742 5.984915813368439 0 0 0 +353 1 5.12992784003009 3.4199518933533937 5.12992784003009 0 0 0 +354 1 5.984915813368439 4.274939866691742 5.12992784003009 0 0 0 +355 1 5.984915813368439 3.4199518933533937 5.984915813368439 0 0 0 +356 1 5.12992784003009 4.274939866691742 5.984915813368439 0 0 0 +357 1 6.839903786706787 3.4199518933533937 5.12992784003009 0 0 0 +358 1 7.694891760045135 4.274939866691742 5.12992784003009 0 0 0 +359 1 7.694891760045135 3.4199518933533937 5.984915813368439 0 0 0 +360 1 6.839903786706787 4.274939866691742 5.984915813368439 0 0 0 +361 1 0 5.12992784003009 5.12992784003009 0 0 0 +362 1 0.8549879733383484 5.984915813368439 5.12992784003009 0 0 0 +363 1 0.8549879733383484 5.12992784003009 5.984915813368439 0 0 0 +364 1 0 5.984915813368439 5.984915813368439 0 0 0 +365 1 1.7099759466766968 5.12992784003009 5.12992784003009 0 0 0 +366 1 2.564963920015045 5.984915813368439 5.12992784003009 0 0 0 +367 1 2.564963920015045 5.12992784003009 5.984915813368439 0 0 0 +368 1 1.7099759466766968 5.984915813368439 5.984915813368439 0 0 0 +369 1 3.4199518933533937 5.12992784003009 5.12992784003009 0 0 0 +370 1 4.274939866691742 5.984915813368439 5.12992784003009 0 0 0 +371 1 4.274939866691742 5.12992784003009 5.984915813368439 0 0 0 +372 1 3.4199518933533937 5.984915813368439 5.984915813368439 0 0 0 +373 1 5.12992784003009 5.12992784003009 5.12992784003009 0 0 0 +374 1 5.984915813368439 5.984915813368439 5.12992784003009 0 0 0 +375 1 5.984915813368439 5.12992784003009 5.984915813368439 0 0 0 +376 1 5.12992784003009 5.984915813368439 5.984915813368439 0 0 0 +377 1 6.839903786706787 5.12992784003009 5.12992784003009 0 0 0 +378 1 7.694891760045135 5.984915813368439 5.12992784003009 0 0 0 +379 1 7.694891760045135 5.12992784003009 5.984915813368439 0 0 0 +380 1 6.839903786706787 5.984915813368439 5.984915813368439 0 0 0 +381 1 0 6.839903786706787 5.12992784003009 0 0 0 +382 1 0.8549879733383484 7.694891760045135 5.12992784003009 0 0 0 +383 1 0.8549879733383484 6.839903786706787 5.984915813368439 0 0 0 +384 1 0 7.694891760045135 5.984915813368439 0 0 0 +385 1 1.7099759466766968 6.839903786706787 5.12992784003009 0 0 0 +386 1 2.564963920015045 7.694891760045135 5.12992784003009 0 0 0 +387 1 2.564963920015045 6.839903786706787 5.984915813368439 0 0 0 +388 1 1.7099759466766968 7.694891760045135 5.984915813368439 0 0 0 +389 1 3.4199518933533937 6.839903786706787 5.12992784003009 0 0 0 +390 1 4.274939866691742 7.694891760045135 5.12992784003009 0 0 0 +391 1 4.274939866691742 6.839903786706787 5.984915813368439 0 0 0 +392 1 3.4199518933533937 7.694891760045135 5.984915813368439 0 0 0 +393 1 5.12992784003009 6.839903786706787 5.12992784003009 0 0 0 +394 1 5.984915813368439 7.694891760045135 5.12992784003009 0 0 0 +395 1 5.984915813368439 6.839903786706787 5.984915813368439 0 0 0 +396 1 5.12992784003009 7.694891760045135 5.984915813368439 0 0 0 +397 1 6.839903786706787 6.839903786706787 5.12992784003009 0 0 0 +398 1 7.694891760045135 7.694891760045135 5.12992784003009 0 0 0 +399 1 7.694891760045135 6.839903786706787 5.984915813368439 0 0 0 +400 1 6.839903786706787 7.694891760045135 5.984915813368439 0 0 0 +401 1 0 0 6.839903786706787 0 0 0 +402 1 0.8549879733383484 0.8549879733383484 6.839903786706787 0 0 0 +403 1 0.8549879733383484 0 7.694891760045135 0 0 0 +404 1 0 0.8549879733383484 7.694891760045135 0 0 0 +405 1 1.7099759466766968 0 6.839903786706787 0 0 0 +406 1 2.564963920015045 0.8549879733383484 6.839903786706787 0 0 0 +407 1 2.564963920015045 0 7.694891760045135 0 0 0 +408 1 1.7099759466766968 0.8549879733383484 7.694891760045135 0 0 0 +409 1 3.4199518933533937 0 6.839903786706787 0 0 0 +410 1 4.274939866691742 0.8549879733383484 6.839903786706787 0 0 0 +411 1 4.274939866691742 0 7.694891760045135 0 0 0 +412 1 3.4199518933533937 0.8549879733383484 7.694891760045135 0 0 0 +413 1 5.12992784003009 0 6.839903786706787 0 0 0 +414 1 5.984915813368439 0.8549879733383484 6.839903786706787 0 0 0 +415 1 5.984915813368439 0 7.694891760045135 0 0 0 +416 1 5.12992784003009 0.8549879733383484 7.694891760045135 0 0 0 +417 1 6.839903786706787 0 6.839903786706787 0 0 0 +418 1 7.694891760045135 0.8549879733383484 6.839903786706787 0 0 0 +419 1 7.694891760045135 0 7.694891760045135 0 0 0 +420 1 6.839903786706787 0.8549879733383484 7.694891760045135 0 0 0 +421 1 0 1.7099759466766968 6.839903786706787 0 0 0 +422 1 0.8549879733383484 2.564963920015045 6.839903786706787 0 0 0 +423 1 0.8549879733383484 1.7099759466766968 7.694891760045135 0 0 0 +424 1 0 2.564963920015045 7.694891760045135 0 0 0 +425 1 1.7099759466766968 1.7099759466766968 6.839903786706787 0 0 0 +426 1 2.564963920015045 2.564963920015045 6.839903786706787 0 0 0 +427 1 2.564963920015045 1.7099759466766968 7.694891760045135 0 0 0 +428 1 1.7099759466766968 2.564963920015045 7.694891760045135 0 0 0 +429 1 3.4199518933533937 1.7099759466766968 6.839903786706787 0 0 0 +430 1 4.274939866691742 2.564963920015045 6.839903786706787 0 0 0 +431 1 4.274939866691742 1.7099759466766968 7.694891760045135 0 0 0 +432 1 3.4199518933533937 2.564963920015045 7.694891760045135 0 0 0 +433 1 5.12992784003009 1.7099759466766968 6.839903786706787 0 0 0 +434 1 5.984915813368439 2.564963920015045 6.839903786706787 0 0 0 +435 1 5.984915813368439 1.7099759466766968 7.694891760045135 0 0 0 +436 1 5.12992784003009 2.564963920015045 7.694891760045135 0 0 0 +437 1 6.839903786706787 1.7099759466766968 6.839903786706787 0 0 0 +438 1 7.694891760045135 2.564963920015045 6.839903786706787 0 0 0 +439 1 7.694891760045135 1.7099759466766968 7.694891760045135 0 0 0 +440 1 6.839903786706787 2.564963920015045 7.694891760045135 0 0 0 +441 1 0 3.4199518933533937 6.839903786706787 0 0 0 +442 1 0.8549879733383484 4.274939866691742 6.839903786706787 0 0 0 +443 1 0.8549879733383484 3.4199518933533937 7.694891760045135 0 0 0 +444 1 0 4.274939866691742 7.694891760045135 0 0 0 +445 1 1.7099759466766968 3.4199518933533937 6.839903786706787 0 0 0 +446 1 2.564963920015045 4.274939866691742 6.839903786706787 0 0 0 +447 1 2.564963920015045 3.4199518933533937 7.694891760045135 0 0 0 +448 1 1.7099759466766968 4.274939866691742 7.694891760045135 0 0 0 +449 1 3.4199518933533937 3.4199518933533937 6.839903786706787 0 0 0 +450 1 4.274939866691742 4.274939866691742 6.839903786706787 0 0 0 +451 1 4.274939866691742 3.4199518933533937 7.694891760045135 0 0 0 +452 1 3.4199518933533937 4.274939866691742 7.694891760045135 0 0 0 +453 1 5.12992784003009 3.4199518933533937 6.839903786706787 0 0 0 +454 1 5.984915813368439 4.274939866691742 6.839903786706787 0 0 0 +455 1 5.984915813368439 3.4199518933533937 7.694891760045135 0 0 0 +456 1 5.12992784003009 4.274939866691742 7.694891760045135 0 0 0 +457 1 6.839903786706787 3.4199518933533937 6.839903786706787 0 0 0 +458 1 7.694891760045135 4.274939866691742 6.839903786706787 0 0 0 +459 1 7.694891760045135 3.4199518933533937 7.694891760045135 0 0 0 +460 1 6.839903786706787 4.274939866691742 7.694891760045135 0 0 0 +461 1 0 5.12992784003009 6.839903786706787 0 0 0 +462 1 0.8549879733383484 5.984915813368439 6.839903786706787 0 0 0 +463 1 0.8549879733383484 5.12992784003009 7.694891760045135 0 0 0 +464 1 0 5.984915813368439 7.694891760045135 0 0 0 +465 1 1.7099759466766968 5.12992784003009 6.839903786706787 0 0 0 +466 1 2.564963920015045 5.984915813368439 6.839903786706787 0 0 0 +467 1 2.564963920015045 5.12992784003009 7.694891760045135 0 0 0 +468 1 1.7099759466766968 5.984915813368439 7.694891760045135 0 0 0 +469 1 3.4199518933533937 5.12992784003009 6.839903786706787 0 0 0 +470 1 4.274939866691742 5.984915813368439 6.839903786706787 0 0 0 +471 1 4.274939866691742 5.12992784003009 7.694891760045135 0 0 0 +472 1 3.4199518933533937 5.984915813368439 7.694891760045135 0 0 0 +473 1 5.12992784003009 5.12992784003009 6.839903786706787 0 0 0 +474 1 5.984915813368439 5.984915813368439 6.839903786706787 0 0 0 +475 1 5.984915813368439 5.12992784003009 7.694891760045135 0 0 0 +476 1 5.12992784003009 5.984915813368439 7.694891760045135 0 0 0 +477 1 6.839903786706787 5.12992784003009 6.839903786706787 0 0 0 +478 1 7.694891760045135 5.984915813368439 6.839903786706787 0 0 0 +479 1 7.694891760045135 5.12992784003009 7.694891760045135 0 0 0 +480 1 6.839903786706787 5.984915813368439 7.694891760045135 0 0 0 +481 1 0 6.839903786706787 6.839903786706787 0 0 0 +482 1 0.8549879733383484 7.694891760045135 6.839903786706787 0 0 0 +483 1 0.8549879733383484 6.839903786706787 7.694891760045135 0 0 0 +484 1 0 7.694891760045135 7.694891760045135 0 0 0 +485 1 1.7099759466766968 6.839903786706787 6.839903786706787 0 0 0 +486 1 2.564963920015045 7.694891760045135 6.839903786706787 0 0 0 +487 1 2.564963920015045 6.839903786706787 7.694891760045135 0 0 0 +488 1 1.7099759466766968 7.694891760045135 7.694891760045135 0 0 0 +489 1 3.4199518933533937 6.839903786706787 6.839903786706787 0 0 0 +490 1 4.274939866691742 7.694891760045135 6.839903786706787 0 0 0 +491 1 4.274939866691742 6.839903786706787 7.694891760045135 0 0 0 +492 1 3.4199518933533937 7.694891760045135 7.694891760045135 0 0 0 +493 1 5.12992784003009 6.839903786706787 6.839903786706787 0 0 0 +494 1 5.984915813368439 7.694891760045135 6.839903786706787 0 0 0 +495 1 5.984915813368439 6.839903786706787 7.694891760045135 0 0 0 +496 1 5.12992784003009 7.694891760045135 7.694891760045135 0 0 0 +497 1 6.839903786706787 6.839903786706787 6.839903786706787 0 0 0 +498 1 7.694891760045135 7.694891760045135 6.839903786706787 0 0 0 +499 1 7.694891760045135 6.839903786706787 7.694891760045135 0 0 0 +500 1 6.839903786706787 7.694891760045135 7.694891760045135 0 0 0 + +Velocities + +1 0 0 0 +2 0 0 0 +3 0 0 0 +4 0 0 0 +5 0 0 0 +6 0 0 0 +7 0 0 0 +8 0 0 0 +9 0 0 0 +10 0 0 0 +11 0 0 0 +12 0 0 0 +13 0 0 0 +14 0 0 0 +15 0 0 0 +16 0 0 0 +17 0 0 0 +18 0 0 0 +19 0 0 0 +20 0 0 0 +21 0 0 0 +22 0 0 0 +23 0 0 0 +24 0 0 0 +25 0 0 0 +26 0 0 0 +27 0 0 0 +28 0 0 0 +29 0 0 0 +30 0 0 0 +31 0 0 0 +32 0 0 0 +33 0 0 0 +34 0 0 0 +35 0 0 0 +36 0 0 0 +37 0 0 0 +38 0 0 0 +39 0 0 0 +40 0 0 0 +41 0 0 0 +42 0 0 0 +43 0 0 0 +44 0 0 0 +45 0 0 0 +46 0 0 0 +47 0 0 0 +48 0 0 0 +49 0 0 0 +50 0 0 0 +51 0 0 0 +52 0 0 0 +53 0 0 0 +54 0 0 0 +55 0 0 0 +56 0 0 0 +57 0 0 0 +58 0 0 0 +59 0 0 0 +60 0 0 0 +61 0 0 0 +62 0 0 0 +63 0 0 0 +64 0 0 0 +65 0 0 0 +66 0 0 0 +67 0 0 0 +68 0 0 0 +69 0 0 0 +70 0 0 0 +71 0 0 0 +72 0 0 0 +73 0 0 0 +74 0 0 0 +75 0 0 0 +76 0 0 0 +77 0 0 0 +78 0 0 0 +79 0 0 0 +80 0 0 0 +81 0 0 0 +82 0 0 0 +83 0 0 0 +84 0 0 0 +85 0 0 0 +86 0 0 0 +87 0 0 0 +88 0 0 0 +89 0 0 0 +90 0 0 0 +91 0 0 0 +92 0 0 0 +93 0 0 0 +94 0 0 0 +95 0 0 0 +96 0 0 0 +97 0 0 0 +98 0 0 0 +99 0 0 0 +100 0 0 0 +101 0 0 0 +102 0 0 0 +103 0 0 0 +104 0 0 0 +105 0 0 0 +106 0 0 0 +107 0 0 0 +108 0 0 0 +109 0 0 0 +110 0 0 0 +111 0 0 0 +112 0 0 0 +113 0 0 0 +114 0 0 0 +115 0 0 0 +116 0 0 0 +117 0 0 0 +118 0 0 0 +119 0 0 0 +120 0 0 0 +121 0 0 0 +122 0 0 0 +123 0 0 0 +124 0 0 0 +125 0 0 0 +126 0 0 0 +127 0 0 0 +128 0 0 0 +129 0 0 0 +130 0 0 0 +131 0 0 0 +132 0 0 0 +133 0 0 0 +134 0 0 0 +135 0 0 0 +136 0 0 0 +137 0 0 0 +138 0 0 0 +139 0 0 0 +140 0 0 0 +141 0 0 0 +142 0 0 0 +143 0 0 0 +144 0 0 0 +145 0 0 0 +146 0 0 0 +147 0 0 0 +148 0 0 0 +149 0 0 0 +150 0 0 0 +151 0 0 0 +152 0 0 0 +153 0 0 0 +154 0 0 0 +155 0 0 0 +156 0 0 0 +157 0 0 0 +158 0 0 0 +159 0 0 0 +160 0 0 0 +161 0 0 0 +162 0 0 0 +163 0 0 0 +164 0 0 0 +165 0 0 0 +166 0 0 0 +167 0 0 0 +168 0 0 0 +169 0 0 0 +170 0 0 0 +171 0 0 0 +172 0 0 0 +173 0 0 0 +174 0 0 0 +175 0 0 0 +176 0 0 0 +177 0 0 0 +178 0 0 0 +179 0 0 0 +180 0 0 0 +181 0 0 0 +182 0 0 0 +183 0 0 0 +184 0 0 0 +185 0 0 0 +186 0 0 0 +187 0 0 0 +188 0 0 0 +189 0 0 0 +190 0 0 0 +191 0 0 0 +192 0 0 0 +193 0 0 0 +194 0 0 0 +195 0 0 0 +196 0 0 0 +197 0 0 0 +198 0 0 0 +199 0 0 0 +200 0 0 0 +201 0 0 0 +202 0 0 0 +203 0 0 0 +204 0 0 0 +205 0 0 0 +206 0 0 0 +207 0 0 0 +208 0 0 0 +209 0 0 0 +210 0 0 0 +211 0 0 0 +212 0 0 0 +213 0 0 0 +214 0 0 0 +215 0 0 0 +216 0 0 0 +217 0 0 0 +218 0 0 0 +219 0 0 0 +220 0 0 0 +221 0 0 0 +222 0 0 0 +223 0 0 0 +224 0 0 0 +225 0 0 0 +226 0 0 0 +227 0 0 0 +228 0 0 0 +229 0 0 0 +230 0 0 0 +231 0 0 0 +232 0 0 0 +233 0 0 0 +234 0 0 0 +235 0 0 0 +236 0 0 0 +237 0 0 0 +238 0 0 0 +239 0 0 0 +240 0 0 0 +241 0 0 0 +242 0 0 0 +243 0 0 0 +244 0 0 0 +245 0 0 0 +246 0 0 0 +247 0 0 0 +248 0 0 0 +249 0 0 0 +250 0 0 0 +251 0 0 0 +252 0 0 0 +253 0 0 0 +254 0 0 0 +255 0 0 0 +256 0 0 0 +257 0 0 0 +258 0 0 0 +259 0 0 0 +260 0 0 0 +261 0 0 0 +262 0 0 0 +263 0 0 0 +264 0 0 0 +265 0 0 0 +266 0 0 0 +267 0 0 0 +268 0 0 0 +269 0 0 0 +270 0 0 0 +271 0 0 0 +272 0 0 0 +273 0 0 0 +274 0 0 0 +275 0 0 0 +276 0 0 0 +277 0 0 0 +278 0 0 0 +279 0 0 0 +280 0 0 0 +281 0 0 0 +282 0 0 0 +283 0 0 0 +284 0 0 0 +285 0 0 0 +286 0 0 0 +287 0 0 0 +288 0 0 0 +289 0 0 0 +290 0 0 0 +291 0 0 0 +292 0 0 0 +293 0 0 0 +294 0 0 0 +295 0 0 0 +296 0 0 0 +297 0 0 0 +298 0 0 0 +299 0 0 0 +300 0 0 0 +301 0 0 0 +302 0 0 0 +303 0 0 0 +304 0 0 0 +305 0 0 0 +306 0 0 0 +307 0 0 0 +308 0 0 0 +309 0 0 0 +310 0 0 0 +311 0 0 0 +312 0 0 0 +313 0 0 0 +314 0 0 0 +315 0 0 0 +316 0 0 0 +317 0 0 0 +318 0 0 0 +319 0 0 0 +320 0 0 0 +321 0 0 0 +322 0 0 0 +323 0 0 0 +324 0 0 0 +325 0 0 0 +326 0 0 0 +327 0 0 0 +328 0 0 0 +329 0 0 0 +330 0 0 0 +331 0 0 0 +332 0 0 0 +333 0 0 0 +334 0 0 0 +335 0 0 0 +336 0 0 0 +337 0 0 0 +338 0 0 0 +339 0 0 0 +340 0 0 0 +341 0 0 0 +342 0 0 0 +343 0 0 0 +344 0 0 0 +345 0 0 0 +346 0 0 0 +347 0 0 0 +348 0 0 0 +349 0 0 0 +350 0 0 0 +351 0 0 0 +352 0 0 0 +353 0 0 0 +354 0 0 0 +355 0 0 0 +356 0 0 0 +357 0 0 0 +358 0 0 0 +359 0 0 0 +360 0 0 0 +361 0 0 0 +362 0 0 0 +363 0 0 0 +364 0 0 0 +365 0 0 0 +366 0 0 0 +367 0 0 0 +368 0 0 0 +369 0 0 0 +370 0 0 0 +371 0 0 0 +372 0 0 0 +373 0 0 0 +374 0 0 0 +375 0 0 0 +376 0 0 0 +377 0 0 0 +378 0 0 0 +379 0 0 0 +380 0 0 0 +381 0 0 0 +382 0 0 0 +383 0 0 0 +384 0 0 0 +385 0 0 0 +386 0 0 0 +387 0 0 0 +388 0 0 0 +389 0 0 0 +390 0 0 0 +391 0 0 0 +392 0 0 0 +393 0 0 0 +394 0 0 0 +395 0 0 0 +396 0 0 0 +397 0 0 0 +398 0 0 0 +399 0 0 0 +400 0 0 0 +401 0 0 0 +402 0 0 0 +403 0 0 0 +404 0 0 0 +405 0 0 0 +406 0 0 0 +407 0 0 0 +408 0 0 0 +409 0 0 0 +410 0 0 0 +411 0 0 0 +412 0 0 0 +413 0 0 0 +414 0 0 0 +415 0 0 0 +416 0 0 0 +417 0 0 0 +418 0 0 0 +419 0 0 0 +420 0 0 0 +421 0 0 0 +422 0 0 0 +423 0 0 0 +424 0 0 0 +425 0 0 0 +426 0 0 0 +427 0 0 0 +428 0 0 0 +429 0 0 0 +430 0 0 0 +431 0 0 0 +432 0 0 0 +433 0 0 0 +434 0 0 0 +435 0 0 0 +436 0 0 0 +437 0 0 0 +438 0 0 0 +439 0 0 0 +440 0 0 0 +441 0 0 0 +442 0 0 0 +443 0 0 0 +444 0 0 0 +445 0 0 0 +446 0 0 0 +447 0 0 0 +448 0 0 0 +449 0 0 0 +450 0 0 0 +451 0 0 0 +452 0 0 0 +453 0 0 0 +454 0 0 0 +455 0 0 0 +456 0 0 0 +457 0 0 0 +458 0 0 0 +459 0 0 0 +460 0 0 0 +461 0 0 0 +462 0 0 0 +463 0 0 0 +464 0 0 0 +465 0 0 0 +466 0 0 0 +467 0 0 0 +468 0 0 0 +469 0 0 0 +470 0 0 0 +471 0 0 0 +472 0 0 0 +473 0 0 0 +474 0 0 0 +475 0 0 0 +476 0 0 0 +477 0 0 0 +478 0 0 0 +479 0 0 0 +480 0 0 0 +481 0 0 0 +482 0 0 0 +483 0 0 0 +484 0 0 0 +485 0 0 0 +486 0 0 0 +487 0 0 0 +488 0 0 0 +489 0 0 0 +490 0 0 0 +491 0 0 0 +492 0 0 0 +493 0 0 0 +494 0 0 0 +495 0 0 0 +496 0 0 0 +497 0 0 0 +498 0 0 0 +499 0 0 0 +500 0 0 0 diff --git a/examples/mdi/data.series.0.9 b/examples/mdi/data.series.0.9 new file mode 100644 index 0000000000..1944096898 --- /dev/null +++ b/examples/mdi/data.series.0.9 @@ -0,0 +1,1018 @@ +LAMMPS data file via write_data, version 2 Jun 2022, timestep = 0 + +500 atoms +1 atom types + +0 8.2207069144349 xlo xhi +0 8.2207069144349 ylo yhi +0 8.2207069144349 zlo zhi + +Masses + +1 1 + +Atoms # atomic + +1 1 0 0 0 0 0 0 +2 1 0.82207069144349 0.82207069144349 0 0 0 0 +3 1 0.82207069144349 0 0.82207069144349 0 0 0 +4 1 0 0.82207069144349 0.82207069144349 0 0 0 +5 1 1.64414138288698 0 0 0 0 0 +6 1 2.46621207433047 0.82207069144349 0 0 0 0 +7 1 2.46621207433047 0 0.82207069144349 0 0 0 +8 1 1.64414138288698 0.82207069144349 0.82207069144349 0 0 0 +9 1 3.28828276577396 0 0 0 0 0 +10 1 4.11035345721745 0.82207069144349 0 0 0 0 +11 1 4.11035345721745 0 0.82207069144349 0 0 0 +12 1 3.28828276577396 0.82207069144349 0.82207069144349 0 0 0 +13 1 4.93242414866094 0 0 0 0 0 +14 1 5.75449484010443 0.82207069144349 0 0 0 0 +15 1 5.75449484010443 0 0.82207069144349 0 0 0 +16 1 4.93242414866094 0.82207069144349 0.82207069144349 0 0 0 +17 1 6.57656553154792 0 0 0 0 0 +18 1 7.39863622299141 0.82207069144349 0 0 0 0 +19 1 7.39863622299141 0 0.82207069144349 0 0 0 +20 1 6.57656553154792 0.82207069144349 0.82207069144349 0 0 0 +21 1 0 1.64414138288698 0 0 0 0 +22 1 0.82207069144349 2.46621207433047 0 0 0 0 +23 1 0.82207069144349 1.64414138288698 0.82207069144349 0 0 0 +24 1 0 2.46621207433047 0.82207069144349 0 0 0 +25 1 1.64414138288698 1.64414138288698 0 0 0 0 +26 1 2.46621207433047 2.46621207433047 0 0 0 0 +27 1 2.46621207433047 1.64414138288698 0.82207069144349 0 0 0 +28 1 1.64414138288698 2.46621207433047 0.82207069144349 0 0 0 +29 1 3.28828276577396 1.64414138288698 0 0 0 0 +30 1 4.11035345721745 2.46621207433047 0 0 0 0 +31 1 4.11035345721745 1.64414138288698 0.82207069144349 0 0 0 +32 1 3.28828276577396 2.46621207433047 0.82207069144349 0 0 0 +33 1 4.93242414866094 1.64414138288698 0 0 0 0 +34 1 5.75449484010443 2.46621207433047 0 0 0 0 +35 1 5.75449484010443 1.64414138288698 0.82207069144349 0 0 0 +36 1 4.93242414866094 2.46621207433047 0.82207069144349 0 0 0 +37 1 6.57656553154792 1.64414138288698 0 0 0 0 +38 1 7.39863622299141 2.46621207433047 0 0 0 0 +39 1 7.39863622299141 1.64414138288698 0.82207069144349 0 0 0 +40 1 6.57656553154792 2.46621207433047 0.82207069144349 0 0 0 +41 1 0 3.28828276577396 0 0 0 0 +42 1 0.82207069144349 4.11035345721745 0 0 0 0 +43 1 0.82207069144349 3.28828276577396 0.82207069144349 0 0 0 +44 1 0 4.11035345721745 0.82207069144349 0 0 0 +45 1 1.64414138288698 3.28828276577396 0 0 0 0 +46 1 2.46621207433047 4.11035345721745 0 0 0 0 +47 1 2.46621207433047 3.28828276577396 0.82207069144349 0 0 0 +48 1 1.64414138288698 4.11035345721745 0.82207069144349 0 0 0 +49 1 3.28828276577396 3.28828276577396 0 0 0 0 +50 1 4.11035345721745 4.11035345721745 0 0 0 0 +51 1 4.11035345721745 3.28828276577396 0.82207069144349 0 0 0 +52 1 3.28828276577396 4.11035345721745 0.82207069144349 0 0 0 +53 1 4.93242414866094 3.28828276577396 0 0 0 0 +54 1 5.75449484010443 4.11035345721745 0 0 0 0 +55 1 5.75449484010443 3.28828276577396 0.82207069144349 0 0 0 +56 1 4.93242414866094 4.11035345721745 0.82207069144349 0 0 0 +57 1 6.57656553154792 3.28828276577396 0 0 0 0 +58 1 7.39863622299141 4.11035345721745 0 0 0 0 +59 1 7.39863622299141 3.28828276577396 0.82207069144349 0 0 0 +60 1 6.57656553154792 4.11035345721745 0.82207069144349 0 0 0 +61 1 0 4.93242414866094 0 0 0 0 +62 1 0.82207069144349 5.75449484010443 0 0 0 0 +63 1 0.82207069144349 4.93242414866094 0.82207069144349 0 0 0 +64 1 0 5.75449484010443 0.82207069144349 0 0 0 +65 1 1.64414138288698 4.93242414866094 0 0 0 0 +66 1 2.46621207433047 5.75449484010443 0 0 0 0 +67 1 2.46621207433047 4.93242414866094 0.82207069144349 0 0 0 +68 1 1.64414138288698 5.75449484010443 0.82207069144349 0 0 0 +69 1 3.28828276577396 4.93242414866094 0 0 0 0 +70 1 4.11035345721745 5.75449484010443 0 0 0 0 +71 1 4.11035345721745 4.93242414866094 0.82207069144349 0 0 0 +72 1 3.28828276577396 5.75449484010443 0.82207069144349 0 0 0 +73 1 4.93242414866094 4.93242414866094 0 0 0 0 +74 1 5.75449484010443 5.75449484010443 0 0 0 0 +75 1 5.75449484010443 4.93242414866094 0.82207069144349 0 0 0 +76 1 4.93242414866094 5.75449484010443 0.82207069144349 0 0 0 +77 1 6.57656553154792 4.93242414866094 0 0 0 0 +78 1 7.39863622299141 5.75449484010443 0 0 0 0 +79 1 7.39863622299141 4.93242414866094 0.82207069144349 0 0 0 +80 1 6.57656553154792 5.75449484010443 0.82207069144349 0 0 0 +81 1 0 6.57656553154792 0 0 0 0 +82 1 0.82207069144349 7.39863622299141 0 0 0 0 +83 1 0.82207069144349 6.57656553154792 0.82207069144349 0 0 0 +84 1 0 7.39863622299141 0.82207069144349 0 0 0 +85 1 1.64414138288698 6.57656553154792 0 0 0 0 +86 1 2.46621207433047 7.39863622299141 0 0 0 0 +87 1 2.46621207433047 6.57656553154792 0.82207069144349 0 0 0 +88 1 1.64414138288698 7.39863622299141 0.82207069144349 0 0 0 +89 1 3.28828276577396 6.57656553154792 0 0 0 0 +90 1 4.11035345721745 7.39863622299141 0 0 0 0 +91 1 4.11035345721745 6.57656553154792 0.82207069144349 0 0 0 +92 1 3.28828276577396 7.39863622299141 0.82207069144349 0 0 0 +93 1 4.93242414866094 6.57656553154792 0 0 0 0 +94 1 5.75449484010443 7.39863622299141 0 0 0 0 +95 1 5.75449484010443 6.57656553154792 0.82207069144349 0 0 0 +96 1 4.93242414866094 7.39863622299141 0.82207069144349 0 0 0 +97 1 6.57656553154792 6.57656553154792 0 0 0 0 +98 1 7.39863622299141 7.39863622299141 0 0 0 0 +99 1 7.39863622299141 6.57656553154792 0.82207069144349 0 0 0 +100 1 6.57656553154792 7.39863622299141 0.82207069144349 0 0 0 +101 1 0 0 1.64414138288698 0 0 0 +102 1 0.82207069144349 0.82207069144349 1.64414138288698 0 0 0 +103 1 0.82207069144349 0 2.46621207433047 0 0 0 +104 1 0 0.82207069144349 2.46621207433047 0 0 0 +105 1 1.64414138288698 0 1.64414138288698 0 0 0 +106 1 2.46621207433047 0.82207069144349 1.64414138288698 0 0 0 +107 1 2.46621207433047 0 2.46621207433047 0 0 0 +108 1 1.64414138288698 0.82207069144349 2.46621207433047 0 0 0 +109 1 3.28828276577396 0 1.64414138288698 0 0 0 +110 1 4.11035345721745 0.82207069144349 1.64414138288698 0 0 0 +111 1 4.11035345721745 0 2.46621207433047 0 0 0 +112 1 3.28828276577396 0.82207069144349 2.46621207433047 0 0 0 +113 1 4.93242414866094 0 1.64414138288698 0 0 0 +114 1 5.75449484010443 0.82207069144349 1.64414138288698 0 0 0 +115 1 5.75449484010443 0 2.46621207433047 0 0 0 +116 1 4.93242414866094 0.82207069144349 2.46621207433047 0 0 0 +117 1 6.57656553154792 0 1.64414138288698 0 0 0 +118 1 7.39863622299141 0.82207069144349 1.64414138288698 0 0 0 +119 1 7.39863622299141 0 2.46621207433047 0 0 0 +120 1 6.57656553154792 0.82207069144349 2.46621207433047 0 0 0 +121 1 0 1.64414138288698 1.64414138288698 0 0 0 +122 1 0.82207069144349 2.46621207433047 1.64414138288698 0 0 0 +123 1 0.82207069144349 1.64414138288698 2.46621207433047 0 0 0 +124 1 0 2.46621207433047 2.46621207433047 0 0 0 +125 1 1.64414138288698 1.64414138288698 1.64414138288698 0 0 0 +126 1 2.46621207433047 2.46621207433047 1.64414138288698 0 0 0 +127 1 2.46621207433047 1.64414138288698 2.46621207433047 0 0 0 +128 1 1.64414138288698 2.46621207433047 2.46621207433047 0 0 0 +129 1 3.28828276577396 1.64414138288698 1.64414138288698 0 0 0 +130 1 4.11035345721745 2.46621207433047 1.64414138288698 0 0 0 +131 1 4.11035345721745 1.64414138288698 2.46621207433047 0 0 0 +132 1 3.28828276577396 2.46621207433047 2.46621207433047 0 0 0 +133 1 4.93242414866094 1.64414138288698 1.64414138288698 0 0 0 +134 1 5.75449484010443 2.46621207433047 1.64414138288698 0 0 0 +135 1 5.75449484010443 1.64414138288698 2.46621207433047 0 0 0 +136 1 4.93242414866094 2.46621207433047 2.46621207433047 0 0 0 +137 1 6.57656553154792 1.64414138288698 1.64414138288698 0 0 0 +138 1 7.39863622299141 2.46621207433047 1.64414138288698 0 0 0 +139 1 7.39863622299141 1.64414138288698 2.46621207433047 0 0 0 +140 1 6.57656553154792 2.46621207433047 2.46621207433047 0 0 0 +141 1 0 3.28828276577396 1.64414138288698 0 0 0 +142 1 0.82207069144349 4.11035345721745 1.64414138288698 0 0 0 +143 1 0.82207069144349 3.28828276577396 2.46621207433047 0 0 0 +144 1 0 4.11035345721745 2.46621207433047 0 0 0 +145 1 1.64414138288698 3.28828276577396 1.64414138288698 0 0 0 +146 1 2.46621207433047 4.11035345721745 1.64414138288698 0 0 0 +147 1 2.46621207433047 3.28828276577396 2.46621207433047 0 0 0 +148 1 1.64414138288698 4.11035345721745 2.46621207433047 0 0 0 +149 1 3.28828276577396 3.28828276577396 1.64414138288698 0 0 0 +150 1 4.11035345721745 4.11035345721745 1.64414138288698 0 0 0 +151 1 4.11035345721745 3.28828276577396 2.46621207433047 0 0 0 +152 1 3.28828276577396 4.11035345721745 2.46621207433047 0 0 0 +153 1 4.93242414866094 3.28828276577396 1.64414138288698 0 0 0 +154 1 5.75449484010443 4.11035345721745 1.64414138288698 0 0 0 +155 1 5.75449484010443 3.28828276577396 2.46621207433047 0 0 0 +156 1 4.93242414866094 4.11035345721745 2.46621207433047 0 0 0 +157 1 6.57656553154792 3.28828276577396 1.64414138288698 0 0 0 +158 1 7.39863622299141 4.11035345721745 1.64414138288698 0 0 0 +159 1 7.39863622299141 3.28828276577396 2.46621207433047 0 0 0 +160 1 6.57656553154792 4.11035345721745 2.46621207433047 0 0 0 +161 1 0 4.93242414866094 1.64414138288698 0 0 0 +162 1 0.82207069144349 5.75449484010443 1.64414138288698 0 0 0 +163 1 0.82207069144349 4.93242414866094 2.46621207433047 0 0 0 +164 1 0 5.75449484010443 2.46621207433047 0 0 0 +165 1 1.64414138288698 4.93242414866094 1.64414138288698 0 0 0 +166 1 2.46621207433047 5.75449484010443 1.64414138288698 0 0 0 +167 1 2.46621207433047 4.93242414866094 2.46621207433047 0 0 0 +168 1 1.64414138288698 5.75449484010443 2.46621207433047 0 0 0 +169 1 3.28828276577396 4.93242414866094 1.64414138288698 0 0 0 +170 1 4.11035345721745 5.75449484010443 1.64414138288698 0 0 0 +171 1 4.11035345721745 4.93242414866094 2.46621207433047 0 0 0 +172 1 3.28828276577396 5.75449484010443 2.46621207433047 0 0 0 +173 1 4.93242414866094 4.93242414866094 1.64414138288698 0 0 0 +174 1 5.75449484010443 5.75449484010443 1.64414138288698 0 0 0 +175 1 5.75449484010443 4.93242414866094 2.46621207433047 0 0 0 +176 1 4.93242414866094 5.75449484010443 2.46621207433047 0 0 0 +177 1 6.57656553154792 4.93242414866094 1.64414138288698 0 0 0 +178 1 7.39863622299141 5.75449484010443 1.64414138288698 0 0 0 +179 1 7.39863622299141 4.93242414866094 2.46621207433047 0 0 0 +180 1 6.57656553154792 5.75449484010443 2.46621207433047 0 0 0 +181 1 0 6.57656553154792 1.64414138288698 0 0 0 +182 1 0.82207069144349 7.39863622299141 1.64414138288698 0 0 0 +183 1 0.82207069144349 6.57656553154792 2.46621207433047 0 0 0 +184 1 0 7.39863622299141 2.46621207433047 0 0 0 +185 1 1.64414138288698 6.57656553154792 1.64414138288698 0 0 0 +186 1 2.46621207433047 7.39863622299141 1.64414138288698 0 0 0 +187 1 2.46621207433047 6.57656553154792 2.46621207433047 0 0 0 +188 1 1.64414138288698 7.39863622299141 2.46621207433047 0 0 0 +189 1 3.28828276577396 6.57656553154792 1.64414138288698 0 0 0 +190 1 4.11035345721745 7.39863622299141 1.64414138288698 0 0 0 +191 1 4.11035345721745 6.57656553154792 2.46621207433047 0 0 0 +192 1 3.28828276577396 7.39863622299141 2.46621207433047 0 0 0 +193 1 4.93242414866094 6.57656553154792 1.64414138288698 0 0 0 +194 1 5.75449484010443 7.39863622299141 1.64414138288698 0 0 0 +195 1 5.75449484010443 6.57656553154792 2.46621207433047 0 0 0 +196 1 4.93242414866094 7.39863622299141 2.46621207433047 0 0 0 +197 1 6.57656553154792 6.57656553154792 1.64414138288698 0 0 0 +198 1 7.39863622299141 7.39863622299141 1.64414138288698 0 0 0 +199 1 7.39863622299141 6.57656553154792 2.46621207433047 0 0 0 +200 1 6.57656553154792 7.39863622299141 2.46621207433047 0 0 0 +201 1 0 0 3.28828276577396 0 0 0 +202 1 0.82207069144349 0.82207069144349 3.28828276577396 0 0 0 +203 1 0.82207069144349 0 4.11035345721745 0 0 0 +204 1 0 0.82207069144349 4.11035345721745 0 0 0 +205 1 1.64414138288698 0 3.28828276577396 0 0 0 +206 1 2.46621207433047 0.82207069144349 3.28828276577396 0 0 0 +207 1 2.46621207433047 0 4.11035345721745 0 0 0 +208 1 1.64414138288698 0.82207069144349 4.11035345721745 0 0 0 +209 1 3.28828276577396 0 3.28828276577396 0 0 0 +210 1 4.11035345721745 0.82207069144349 3.28828276577396 0 0 0 +211 1 4.11035345721745 0 4.11035345721745 0 0 0 +212 1 3.28828276577396 0.82207069144349 4.11035345721745 0 0 0 +213 1 4.93242414866094 0 3.28828276577396 0 0 0 +214 1 5.75449484010443 0.82207069144349 3.28828276577396 0 0 0 +215 1 5.75449484010443 0 4.11035345721745 0 0 0 +216 1 4.93242414866094 0.82207069144349 4.11035345721745 0 0 0 +217 1 6.57656553154792 0 3.28828276577396 0 0 0 +218 1 7.39863622299141 0.82207069144349 3.28828276577396 0 0 0 +219 1 7.39863622299141 0 4.11035345721745 0 0 0 +220 1 6.57656553154792 0.82207069144349 4.11035345721745 0 0 0 +221 1 0 1.64414138288698 3.28828276577396 0 0 0 +222 1 0.82207069144349 2.46621207433047 3.28828276577396 0 0 0 +223 1 0.82207069144349 1.64414138288698 4.11035345721745 0 0 0 +224 1 0 2.46621207433047 4.11035345721745 0 0 0 +225 1 1.64414138288698 1.64414138288698 3.28828276577396 0 0 0 +226 1 2.46621207433047 2.46621207433047 3.28828276577396 0 0 0 +227 1 2.46621207433047 1.64414138288698 4.11035345721745 0 0 0 +228 1 1.64414138288698 2.46621207433047 4.11035345721745 0 0 0 +229 1 3.28828276577396 1.64414138288698 3.28828276577396 0 0 0 +230 1 4.11035345721745 2.46621207433047 3.28828276577396 0 0 0 +231 1 4.11035345721745 1.64414138288698 4.11035345721745 0 0 0 +232 1 3.28828276577396 2.46621207433047 4.11035345721745 0 0 0 +233 1 4.93242414866094 1.64414138288698 3.28828276577396 0 0 0 +234 1 5.75449484010443 2.46621207433047 3.28828276577396 0 0 0 +235 1 5.75449484010443 1.64414138288698 4.11035345721745 0 0 0 +236 1 4.93242414866094 2.46621207433047 4.11035345721745 0 0 0 +237 1 6.57656553154792 1.64414138288698 3.28828276577396 0 0 0 +238 1 7.39863622299141 2.46621207433047 3.28828276577396 0 0 0 +239 1 7.39863622299141 1.64414138288698 4.11035345721745 0 0 0 +240 1 6.57656553154792 2.46621207433047 4.11035345721745 0 0 0 +241 1 0 3.28828276577396 3.28828276577396 0 0 0 +242 1 0.82207069144349 4.11035345721745 3.28828276577396 0 0 0 +243 1 0.82207069144349 3.28828276577396 4.11035345721745 0 0 0 +244 1 0 4.11035345721745 4.11035345721745 0 0 0 +245 1 1.64414138288698 3.28828276577396 3.28828276577396 0 0 0 +246 1 2.46621207433047 4.11035345721745 3.28828276577396 0 0 0 +247 1 2.46621207433047 3.28828276577396 4.11035345721745 0 0 0 +248 1 1.64414138288698 4.11035345721745 4.11035345721745 0 0 0 +249 1 3.28828276577396 3.28828276577396 3.28828276577396 0 0 0 +250 1 4.11035345721745 4.11035345721745 3.28828276577396 0 0 0 +251 1 4.11035345721745 3.28828276577396 4.11035345721745 0 0 0 +252 1 3.28828276577396 4.11035345721745 4.11035345721745 0 0 0 +253 1 4.93242414866094 3.28828276577396 3.28828276577396 0 0 0 +254 1 5.75449484010443 4.11035345721745 3.28828276577396 0 0 0 +255 1 5.75449484010443 3.28828276577396 4.11035345721745 0 0 0 +256 1 4.93242414866094 4.11035345721745 4.11035345721745 0 0 0 +257 1 6.57656553154792 3.28828276577396 3.28828276577396 0 0 0 +258 1 7.39863622299141 4.11035345721745 3.28828276577396 0 0 0 +259 1 7.39863622299141 3.28828276577396 4.11035345721745 0 0 0 +260 1 6.57656553154792 4.11035345721745 4.11035345721745 0 0 0 +261 1 0 4.93242414866094 3.28828276577396 0 0 0 +262 1 0.82207069144349 5.75449484010443 3.28828276577396 0 0 0 +263 1 0.82207069144349 4.93242414866094 4.11035345721745 0 0 0 +264 1 0 5.75449484010443 4.11035345721745 0 0 0 +265 1 1.64414138288698 4.93242414866094 3.28828276577396 0 0 0 +266 1 2.46621207433047 5.75449484010443 3.28828276577396 0 0 0 +267 1 2.46621207433047 4.93242414866094 4.11035345721745 0 0 0 +268 1 1.64414138288698 5.75449484010443 4.11035345721745 0 0 0 +269 1 3.28828276577396 4.93242414866094 3.28828276577396 0 0 0 +270 1 4.11035345721745 5.75449484010443 3.28828276577396 0 0 0 +271 1 4.11035345721745 4.93242414866094 4.11035345721745 0 0 0 +272 1 3.28828276577396 5.75449484010443 4.11035345721745 0 0 0 +273 1 4.93242414866094 4.93242414866094 3.28828276577396 0 0 0 +274 1 5.75449484010443 5.75449484010443 3.28828276577396 0 0 0 +275 1 5.75449484010443 4.93242414866094 4.11035345721745 0 0 0 +276 1 4.93242414866094 5.75449484010443 4.11035345721745 0 0 0 +277 1 6.57656553154792 4.93242414866094 3.28828276577396 0 0 0 +278 1 7.39863622299141 5.75449484010443 3.28828276577396 0 0 0 +279 1 7.39863622299141 4.93242414866094 4.11035345721745 0 0 0 +280 1 6.57656553154792 5.75449484010443 4.11035345721745 0 0 0 +281 1 0 6.57656553154792 3.28828276577396 0 0 0 +282 1 0.82207069144349 7.39863622299141 3.28828276577396 0 0 0 +283 1 0.82207069144349 6.57656553154792 4.11035345721745 0 0 0 +284 1 0 7.39863622299141 4.11035345721745 0 0 0 +285 1 1.64414138288698 6.57656553154792 3.28828276577396 0 0 0 +286 1 2.46621207433047 7.39863622299141 3.28828276577396 0 0 0 +287 1 2.46621207433047 6.57656553154792 4.11035345721745 0 0 0 +288 1 1.64414138288698 7.39863622299141 4.11035345721745 0 0 0 +289 1 3.28828276577396 6.57656553154792 3.28828276577396 0 0 0 +290 1 4.11035345721745 7.39863622299141 3.28828276577396 0 0 0 +291 1 4.11035345721745 6.57656553154792 4.11035345721745 0 0 0 +292 1 3.28828276577396 7.39863622299141 4.11035345721745 0 0 0 +293 1 4.93242414866094 6.57656553154792 3.28828276577396 0 0 0 +294 1 5.75449484010443 7.39863622299141 3.28828276577396 0 0 0 +295 1 5.75449484010443 6.57656553154792 4.11035345721745 0 0 0 +296 1 4.93242414866094 7.39863622299141 4.11035345721745 0 0 0 +297 1 6.57656553154792 6.57656553154792 3.28828276577396 0 0 0 +298 1 7.39863622299141 7.39863622299141 3.28828276577396 0 0 0 +299 1 7.39863622299141 6.57656553154792 4.11035345721745 0 0 0 +300 1 6.57656553154792 7.39863622299141 4.11035345721745 0 0 0 +301 1 0 0 4.93242414866094 0 0 0 +302 1 0.82207069144349 0.82207069144349 4.93242414866094 0 0 0 +303 1 0.82207069144349 0 5.75449484010443 0 0 0 +304 1 0 0.82207069144349 5.75449484010443 0 0 0 +305 1 1.64414138288698 0 4.93242414866094 0 0 0 +306 1 2.46621207433047 0.82207069144349 4.93242414866094 0 0 0 +307 1 2.46621207433047 0 5.75449484010443 0 0 0 +308 1 1.64414138288698 0.82207069144349 5.75449484010443 0 0 0 +309 1 3.28828276577396 0 4.93242414866094 0 0 0 +310 1 4.11035345721745 0.82207069144349 4.93242414866094 0 0 0 +311 1 4.11035345721745 0 5.75449484010443 0 0 0 +312 1 3.28828276577396 0.82207069144349 5.75449484010443 0 0 0 +313 1 4.93242414866094 0 4.93242414866094 0 0 0 +314 1 5.75449484010443 0.82207069144349 4.93242414866094 0 0 0 +315 1 5.75449484010443 0 5.75449484010443 0 0 0 +316 1 4.93242414866094 0.82207069144349 5.75449484010443 0 0 0 +317 1 6.57656553154792 0 4.93242414866094 0 0 0 +318 1 7.39863622299141 0.82207069144349 4.93242414866094 0 0 0 +319 1 7.39863622299141 0 5.75449484010443 0 0 0 +320 1 6.57656553154792 0.82207069144349 5.75449484010443 0 0 0 +321 1 0 1.64414138288698 4.93242414866094 0 0 0 +322 1 0.82207069144349 2.46621207433047 4.93242414866094 0 0 0 +323 1 0.82207069144349 1.64414138288698 5.75449484010443 0 0 0 +324 1 0 2.46621207433047 5.75449484010443 0 0 0 +325 1 1.64414138288698 1.64414138288698 4.93242414866094 0 0 0 +326 1 2.46621207433047 2.46621207433047 4.93242414866094 0 0 0 +327 1 2.46621207433047 1.64414138288698 5.75449484010443 0 0 0 +328 1 1.64414138288698 2.46621207433047 5.75449484010443 0 0 0 +329 1 3.28828276577396 1.64414138288698 4.93242414866094 0 0 0 +330 1 4.11035345721745 2.46621207433047 4.93242414866094 0 0 0 +331 1 4.11035345721745 1.64414138288698 5.75449484010443 0 0 0 +332 1 3.28828276577396 2.46621207433047 5.75449484010443 0 0 0 +333 1 4.93242414866094 1.64414138288698 4.93242414866094 0 0 0 +334 1 5.75449484010443 2.46621207433047 4.93242414866094 0 0 0 +335 1 5.75449484010443 1.64414138288698 5.75449484010443 0 0 0 +336 1 4.93242414866094 2.46621207433047 5.75449484010443 0 0 0 +337 1 6.57656553154792 1.64414138288698 4.93242414866094 0 0 0 +338 1 7.39863622299141 2.46621207433047 4.93242414866094 0 0 0 +339 1 7.39863622299141 1.64414138288698 5.75449484010443 0 0 0 +340 1 6.57656553154792 2.46621207433047 5.75449484010443 0 0 0 +341 1 0 3.28828276577396 4.93242414866094 0 0 0 +342 1 0.82207069144349 4.11035345721745 4.93242414866094 0 0 0 +343 1 0.82207069144349 3.28828276577396 5.75449484010443 0 0 0 +344 1 0 4.11035345721745 5.75449484010443 0 0 0 +345 1 1.64414138288698 3.28828276577396 4.93242414866094 0 0 0 +346 1 2.46621207433047 4.11035345721745 4.93242414866094 0 0 0 +347 1 2.46621207433047 3.28828276577396 5.75449484010443 0 0 0 +348 1 1.64414138288698 4.11035345721745 5.75449484010443 0 0 0 +349 1 3.28828276577396 3.28828276577396 4.93242414866094 0 0 0 +350 1 4.11035345721745 4.11035345721745 4.93242414866094 0 0 0 +351 1 4.11035345721745 3.28828276577396 5.75449484010443 0 0 0 +352 1 3.28828276577396 4.11035345721745 5.75449484010443 0 0 0 +353 1 4.93242414866094 3.28828276577396 4.93242414866094 0 0 0 +354 1 5.75449484010443 4.11035345721745 4.93242414866094 0 0 0 +355 1 5.75449484010443 3.28828276577396 5.75449484010443 0 0 0 +356 1 4.93242414866094 4.11035345721745 5.75449484010443 0 0 0 +357 1 6.57656553154792 3.28828276577396 4.93242414866094 0 0 0 +358 1 7.39863622299141 4.11035345721745 4.93242414866094 0 0 0 +359 1 7.39863622299141 3.28828276577396 5.75449484010443 0 0 0 +360 1 6.57656553154792 4.11035345721745 5.75449484010443 0 0 0 +361 1 0 4.93242414866094 4.93242414866094 0 0 0 +362 1 0.82207069144349 5.75449484010443 4.93242414866094 0 0 0 +363 1 0.82207069144349 4.93242414866094 5.75449484010443 0 0 0 +364 1 0 5.75449484010443 5.75449484010443 0 0 0 +365 1 1.64414138288698 4.93242414866094 4.93242414866094 0 0 0 +366 1 2.46621207433047 5.75449484010443 4.93242414866094 0 0 0 +367 1 2.46621207433047 4.93242414866094 5.75449484010443 0 0 0 +368 1 1.64414138288698 5.75449484010443 5.75449484010443 0 0 0 +369 1 3.28828276577396 4.93242414866094 4.93242414866094 0 0 0 +370 1 4.11035345721745 5.75449484010443 4.93242414866094 0 0 0 +371 1 4.11035345721745 4.93242414866094 5.75449484010443 0 0 0 +372 1 3.28828276577396 5.75449484010443 5.75449484010443 0 0 0 +373 1 4.93242414866094 4.93242414866094 4.93242414866094 0 0 0 +374 1 5.75449484010443 5.75449484010443 4.93242414866094 0 0 0 +375 1 5.75449484010443 4.93242414866094 5.75449484010443 0 0 0 +376 1 4.93242414866094 5.75449484010443 5.75449484010443 0 0 0 +377 1 6.57656553154792 4.93242414866094 4.93242414866094 0 0 0 +378 1 7.39863622299141 5.75449484010443 4.93242414866094 0 0 0 +379 1 7.39863622299141 4.93242414866094 5.75449484010443 0 0 0 +380 1 6.57656553154792 5.75449484010443 5.75449484010443 0 0 0 +381 1 0 6.57656553154792 4.93242414866094 0 0 0 +382 1 0.82207069144349 7.39863622299141 4.93242414866094 0 0 0 +383 1 0.82207069144349 6.57656553154792 5.75449484010443 0 0 0 +384 1 0 7.39863622299141 5.75449484010443 0 0 0 +385 1 1.64414138288698 6.57656553154792 4.93242414866094 0 0 0 +386 1 2.46621207433047 7.39863622299141 4.93242414866094 0 0 0 +387 1 2.46621207433047 6.57656553154792 5.75449484010443 0 0 0 +388 1 1.64414138288698 7.39863622299141 5.75449484010443 0 0 0 +389 1 3.28828276577396 6.57656553154792 4.93242414866094 0 0 0 +390 1 4.11035345721745 7.39863622299141 4.93242414866094 0 0 0 +391 1 4.11035345721745 6.57656553154792 5.75449484010443 0 0 0 +392 1 3.28828276577396 7.39863622299141 5.75449484010443 0 0 0 +393 1 4.93242414866094 6.57656553154792 4.93242414866094 0 0 0 +394 1 5.75449484010443 7.39863622299141 4.93242414866094 0 0 0 +395 1 5.75449484010443 6.57656553154792 5.75449484010443 0 0 0 +396 1 4.93242414866094 7.39863622299141 5.75449484010443 0 0 0 +397 1 6.57656553154792 6.57656553154792 4.93242414866094 0 0 0 +398 1 7.39863622299141 7.39863622299141 4.93242414866094 0 0 0 +399 1 7.39863622299141 6.57656553154792 5.75449484010443 0 0 0 +400 1 6.57656553154792 7.39863622299141 5.75449484010443 0 0 0 +401 1 0 0 6.57656553154792 0 0 0 +402 1 0.82207069144349 0.82207069144349 6.57656553154792 0 0 0 +403 1 0.82207069144349 0 7.39863622299141 0 0 0 +404 1 0 0.82207069144349 7.39863622299141 0 0 0 +405 1 1.64414138288698 0 6.57656553154792 0 0 0 +406 1 2.46621207433047 0.82207069144349 6.57656553154792 0 0 0 +407 1 2.46621207433047 0 7.39863622299141 0 0 0 +408 1 1.64414138288698 0.82207069144349 7.39863622299141 0 0 0 +409 1 3.28828276577396 0 6.57656553154792 0 0 0 +410 1 4.11035345721745 0.82207069144349 6.57656553154792 0 0 0 +411 1 4.11035345721745 0 7.39863622299141 0 0 0 +412 1 3.28828276577396 0.82207069144349 7.39863622299141 0 0 0 +413 1 4.93242414866094 0 6.57656553154792 0 0 0 +414 1 5.75449484010443 0.82207069144349 6.57656553154792 0 0 0 +415 1 5.75449484010443 0 7.39863622299141 0 0 0 +416 1 4.93242414866094 0.82207069144349 7.39863622299141 0 0 0 +417 1 6.57656553154792 0 6.57656553154792 0 0 0 +418 1 7.39863622299141 0.82207069144349 6.57656553154792 0 0 0 +419 1 7.39863622299141 0 7.39863622299141 0 0 0 +420 1 6.57656553154792 0.82207069144349 7.39863622299141 0 0 0 +421 1 0 1.64414138288698 6.57656553154792 0 0 0 +422 1 0.82207069144349 2.46621207433047 6.57656553154792 0 0 0 +423 1 0.82207069144349 1.64414138288698 7.39863622299141 0 0 0 +424 1 0 2.46621207433047 7.39863622299141 0 0 0 +425 1 1.64414138288698 1.64414138288698 6.57656553154792 0 0 0 +426 1 2.46621207433047 2.46621207433047 6.57656553154792 0 0 0 +427 1 2.46621207433047 1.64414138288698 7.39863622299141 0 0 0 +428 1 1.64414138288698 2.46621207433047 7.39863622299141 0 0 0 +429 1 3.28828276577396 1.64414138288698 6.57656553154792 0 0 0 +430 1 4.11035345721745 2.46621207433047 6.57656553154792 0 0 0 +431 1 4.11035345721745 1.64414138288698 7.39863622299141 0 0 0 +432 1 3.28828276577396 2.46621207433047 7.39863622299141 0 0 0 +433 1 4.93242414866094 1.64414138288698 6.57656553154792 0 0 0 +434 1 5.75449484010443 2.46621207433047 6.57656553154792 0 0 0 +435 1 5.75449484010443 1.64414138288698 7.39863622299141 0 0 0 +436 1 4.93242414866094 2.46621207433047 7.39863622299141 0 0 0 +437 1 6.57656553154792 1.64414138288698 6.57656553154792 0 0 0 +438 1 7.39863622299141 2.46621207433047 6.57656553154792 0 0 0 +439 1 7.39863622299141 1.64414138288698 7.39863622299141 0 0 0 +440 1 6.57656553154792 2.46621207433047 7.39863622299141 0 0 0 +441 1 0 3.28828276577396 6.57656553154792 0 0 0 +442 1 0.82207069144349 4.11035345721745 6.57656553154792 0 0 0 +443 1 0.82207069144349 3.28828276577396 7.39863622299141 0 0 0 +444 1 0 4.11035345721745 7.39863622299141 0 0 0 +445 1 1.64414138288698 3.28828276577396 6.57656553154792 0 0 0 +446 1 2.46621207433047 4.11035345721745 6.57656553154792 0 0 0 +447 1 2.46621207433047 3.28828276577396 7.39863622299141 0 0 0 +448 1 1.64414138288698 4.11035345721745 7.39863622299141 0 0 0 +449 1 3.28828276577396 3.28828276577396 6.57656553154792 0 0 0 +450 1 4.11035345721745 4.11035345721745 6.57656553154792 0 0 0 +451 1 4.11035345721745 3.28828276577396 7.39863622299141 0 0 0 +452 1 3.28828276577396 4.11035345721745 7.39863622299141 0 0 0 +453 1 4.93242414866094 3.28828276577396 6.57656553154792 0 0 0 +454 1 5.75449484010443 4.11035345721745 6.57656553154792 0 0 0 +455 1 5.75449484010443 3.28828276577396 7.39863622299141 0 0 0 +456 1 4.93242414866094 4.11035345721745 7.39863622299141 0 0 0 +457 1 6.57656553154792 3.28828276577396 6.57656553154792 0 0 0 +458 1 7.39863622299141 4.11035345721745 6.57656553154792 0 0 0 +459 1 7.39863622299141 3.28828276577396 7.39863622299141 0 0 0 +460 1 6.57656553154792 4.11035345721745 7.39863622299141 0 0 0 +461 1 0 4.93242414866094 6.57656553154792 0 0 0 +462 1 0.82207069144349 5.75449484010443 6.57656553154792 0 0 0 +463 1 0.82207069144349 4.93242414866094 7.39863622299141 0 0 0 +464 1 0 5.75449484010443 7.39863622299141 0 0 0 +465 1 1.64414138288698 4.93242414866094 6.57656553154792 0 0 0 +466 1 2.46621207433047 5.75449484010443 6.57656553154792 0 0 0 +467 1 2.46621207433047 4.93242414866094 7.39863622299141 0 0 0 +468 1 1.64414138288698 5.75449484010443 7.39863622299141 0 0 0 +469 1 3.28828276577396 4.93242414866094 6.57656553154792 0 0 0 +470 1 4.11035345721745 5.75449484010443 6.57656553154792 0 0 0 +471 1 4.11035345721745 4.93242414866094 7.39863622299141 0 0 0 +472 1 3.28828276577396 5.75449484010443 7.39863622299141 0 0 0 +473 1 4.93242414866094 4.93242414866094 6.57656553154792 0 0 0 +474 1 5.75449484010443 5.75449484010443 6.57656553154792 0 0 0 +475 1 5.75449484010443 4.93242414866094 7.39863622299141 0 0 0 +476 1 4.93242414866094 5.75449484010443 7.39863622299141 0 0 0 +477 1 6.57656553154792 4.93242414866094 6.57656553154792 0 0 0 +478 1 7.39863622299141 5.75449484010443 6.57656553154792 0 0 0 +479 1 7.39863622299141 4.93242414866094 7.39863622299141 0 0 0 +480 1 6.57656553154792 5.75449484010443 7.39863622299141 0 0 0 +481 1 0 6.57656553154792 6.57656553154792 0 0 0 +482 1 0.82207069144349 7.39863622299141 6.57656553154792 0 0 0 +483 1 0.82207069144349 6.57656553154792 7.39863622299141 0 0 0 +484 1 0 7.39863622299141 7.39863622299141 0 0 0 +485 1 1.64414138288698 6.57656553154792 6.57656553154792 0 0 0 +486 1 2.46621207433047 7.39863622299141 6.57656553154792 0 0 0 +487 1 2.46621207433047 6.57656553154792 7.39863622299141 0 0 0 +488 1 1.64414138288698 7.39863622299141 7.39863622299141 0 0 0 +489 1 3.28828276577396 6.57656553154792 6.57656553154792 0 0 0 +490 1 4.11035345721745 7.39863622299141 6.57656553154792 0 0 0 +491 1 4.11035345721745 6.57656553154792 7.39863622299141 0 0 0 +492 1 3.28828276577396 7.39863622299141 7.39863622299141 0 0 0 +493 1 4.93242414866094 6.57656553154792 6.57656553154792 0 0 0 +494 1 5.75449484010443 7.39863622299141 6.57656553154792 0 0 0 +495 1 5.75449484010443 6.57656553154792 7.39863622299141 0 0 0 +496 1 4.93242414866094 7.39863622299141 7.39863622299141 0 0 0 +497 1 6.57656553154792 6.57656553154792 6.57656553154792 0 0 0 +498 1 7.39863622299141 7.39863622299141 6.57656553154792 0 0 0 +499 1 7.39863622299141 6.57656553154792 7.39863622299141 0 0 0 +500 1 6.57656553154792 7.39863622299141 7.39863622299141 0 0 0 + +Velocities + +1 0 0 0 +2 0 0 0 +3 0 0 0 +4 0 0 0 +5 0 0 0 +6 0 0 0 +7 0 0 0 +8 0 0 0 +9 0 0 0 +10 0 0 0 +11 0 0 0 +12 0 0 0 +13 0 0 0 +14 0 0 0 +15 0 0 0 +16 0 0 0 +17 0 0 0 +18 0 0 0 +19 0 0 0 +20 0 0 0 +21 0 0 0 +22 0 0 0 +23 0 0 0 +24 0 0 0 +25 0 0 0 +26 0 0 0 +27 0 0 0 +28 0 0 0 +29 0 0 0 +30 0 0 0 +31 0 0 0 +32 0 0 0 +33 0 0 0 +34 0 0 0 +35 0 0 0 +36 0 0 0 +37 0 0 0 +38 0 0 0 +39 0 0 0 +40 0 0 0 +41 0 0 0 +42 0 0 0 +43 0 0 0 +44 0 0 0 +45 0 0 0 +46 0 0 0 +47 0 0 0 +48 0 0 0 +49 0 0 0 +50 0 0 0 +51 0 0 0 +52 0 0 0 +53 0 0 0 +54 0 0 0 +55 0 0 0 +56 0 0 0 +57 0 0 0 +58 0 0 0 +59 0 0 0 +60 0 0 0 +61 0 0 0 +62 0 0 0 +63 0 0 0 +64 0 0 0 +65 0 0 0 +66 0 0 0 +67 0 0 0 +68 0 0 0 +69 0 0 0 +70 0 0 0 +71 0 0 0 +72 0 0 0 +73 0 0 0 +74 0 0 0 +75 0 0 0 +76 0 0 0 +77 0 0 0 +78 0 0 0 +79 0 0 0 +80 0 0 0 +81 0 0 0 +82 0 0 0 +83 0 0 0 +84 0 0 0 +85 0 0 0 +86 0 0 0 +87 0 0 0 +88 0 0 0 +89 0 0 0 +90 0 0 0 +91 0 0 0 +92 0 0 0 +93 0 0 0 +94 0 0 0 +95 0 0 0 +96 0 0 0 +97 0 0 0 +98 0 0 0 +99 0 0 0 +100 0 0 0 +101 0 0 0 +102 0 0 0 +103 0 0 0 +104 0 0 0 +105 0 0 0 +106 0 0 0 +107 0 0 0 +108 0 0 0 +109 0 0 0 +110 0 0 0 +111 0 0 0 +112 0 0 0 +113 0 0 0 +114 0 0 0 +115 0 0 0 +116 0 0 0 +117 0 0 0 +118 0 0 0 +119 0 0 0 +120 0 0 0 +121 0 0 0 +122 0 0 0 +123 0 0 0 +124 0 0 0 +125 0 0 0 +126 0 0 0 +127 0 0 0 +128 0 0 0 +129 0 0 0 +130 0 0 0 +131 0 0 0 +132 0 0 0 +133 0 0 0 +134 0 0 0 +135 0 0 0 +136 0 0 0 +137 0 0 0 +138 0 0 0 +139 0 0 0 +140 0 0 0 +141 0 0 0 +142 0 0 0 +143 0 0 0 +144 0 0 0 +145 0 0 0 +146 0 0 0 +147 0 0 0 +148 0 0 0 +149 0 0 0 +150 0 0 0 +151 0 0 0 +152 0 0 0 +153 0 0 0 +154 0 0 0 +155 0 0 0 +156 0 0 0 +157 0 0 0 +158 0 0 0 +159 0 0 0 +160 0 0 0 +161 0 0 0 +162 0 0 0 +163 0 0 0 +164 0 0 0 +165 0 0 0 +166 0 0 0 +167 0 0 0 +168 0 0 0 +169 0 0 0 +170 0 0 0 +171 0 0 0 +172 0 0 0 +173 0 0 0 +174 0 0 0 +175 0 0 0 +176 0 0 0 +177 0 0 0 +178 0 0 0 +179 0 0 0 +180 0 0 0 +181 0 0 0 +182 0 0 0 +183 0 0 0 +184 0 0 0 +185 0 0 0 +186 0 0 0 +187 0 0 0 +188 0 0 0 +189 0 0 0 +190 0 0 0 +191 0 0 0 +192 0 0 0 +193 0 0 0 +194 0 0 0 +195 0 0 0 +196 0 0 0 +197 0 0 0 +198 0 0 0 +199 0 0 0 +200 0 0 0 +201 0 0 0 +202 0 0 0 +203 0 0 0 +204 0 0 0 +205 0 0 0 +206 0 0 0 +207 0 0 0 +208 0 0 0 +209 0 0 0 +210 0 0 0 +211 0 0 0 +212 0 0 0 +213 0 0 0 +214 0 0 0 +215 0 0 0 +216 0 0 0 +217 0 0 0 +218 0 0 0 +219 0 0 0 +220 0 0 0 +221 0 0 0 +222 0 0 0 +223 0 0 0 +224 0 0 0 +225 0 0 0 +226 0 0 0 +227 0 0 0 +228 0 0 0 +229 0 0 0 +230 0 0 0 +231 0 0 0 +232 0 0 0 +233 0 0 0 +234 0 0 0 +235 0 0 0 +236 0 0 0 +237 0 0 0 +238 0 0 0 +239 0 0 0 +240 0 0 0 +241 0 0 0 +242 0 0 0 +243 0 0 0 +244 0 0 0 +245 0 0 0 +246 0 0 0 +247 0 0 0 +248 0 0 0 +249 0 0 0 +250 0 0 0 +251 0 0 0 +252 0 0 0 +253 0 0 0 +254 0 0 0 +255 0 0 0 +256 0 0 0 +257 0 0 0 +258 0 0 0 +259 0 0 0 +260 0 0 0 +261 0 0 0 +262 0 0 0 +263 0 0 0 +264 0 0 0 +265 0 0 0 +266 0 0 0 +267 0 0 0 +268 0 0 0 +269 0 0 0 +270 0 0 0 +271 0 0 0 +272 0 0 0 +273 0 0 0 +274 0 0 0 +275 0 0 0 +276 0 0 0 +277 0 0 0 +278 0 0 0 +279 0 0 0 +280 0 0 0 +281 0 0 0 +282 0 0 0 +283 0 0 0 +284 0 0 0 +285 0 0 0 +286 0 0 0 +287 0 0 0 +288 0 0 0 +289 0 0 0 +290 0 0 0 +291 0 0 0 +292 0 0 0 +293 0 0 0 +294 0 0 0 +295 0 0 0 +296 0 0 0 +297 0 0 0 +298 0 0 0 +299 0 0 0 +300 0 0 0 +301 0 0 0 +302 0 0 0 +303 0 0 0 +304 0 0 0 +305 0 0 0 +306 0 0 0 +307 0 0 0 +308 0 0 0 +309 0 0 0 +310 0 0 0 +311 0 0 0 +312 0 0 0 +313 0 0 0 +314 0 0 0 +315 0 0 0 +316 0 0 0 +317 0 0 0 +318 0 0 0 +319 0 0 0 +320 0 0 0 +321 0 0 0 +322 0 0 0 +323 0 0 0 +324 0 0 0 +325 0 0 0 +326 0 0 0 +327 0 0 0 +328 0 0 0 +329 0 0 0 +330 0 0 0 +331 0 0 0 +332 0 0 0 +333 0 0 0 +334 0 0 0 +335 0 0 0 +336 0 0 0 +337 0 0 0 +338 0 0 0 +339 0 0 0 +340 0 0 0 +341 0 0 0 +342 0 0 0 +343 0 0 0 +344 0 0 0 +345 0 0 0 +346 0 0 0 +347 0 0 0 +348 0 0 0 +349 0 0 0 +350 0 0 0 +351 0 0 0 +352 0 0 0 +353 0 0 0 +354 0 0 0 +355 0 0 0 +356 0 0 0 +357 0 0 0 +358 0 0 0 +359 0 0 0 +360 0 0 0 +361 0 0 0 +362 0 0 0 +363 0 0 0 +364 0 0 0 +365 0 0 0 +366 0 0 0 +367 0 0 0 +368 0 0 0 +369 0 0 0 +370 0 0 0 +371 0 0 0 +372 0 0 0 +373 0 0 0 +374 0 0 0 +375 0 0 0 +376 0 0 0 +377 0 0 0 +378 0 0 0 +379 0 0 0 +380 0 0 0 +381 0 0 0 +382 0 0 0 +383 0 0 0 +384 0 0 0 +385 0 0 0 +386 0 0 0 +387 0 0 0 +388 0 0 0 +389 0 0 0 +390 0 0 0 +391 0 0 0 +392 0 0 0 +393 0 0 0 +394 0 0 0 +395 0 0 0 +396 0 0 0 +397 0 0 0 +398 0 0 0 +399 0 0 0 +400 0 0 0 +401 0 0 0 +402 0 0 0 +403 0 0 0 +404 0 0 0 +405 0 0 0 +406 0 0 0 +407 0 0 0 +408 0 0 0 +409 0 0 0 +410 0 0 0 +411 0 0 0 +412 0 0 0 +413 0 0 0 +414 0 0 0 +415 0 0 0 +416 0 0 0 +417 0 0 0 +418 0 0 0 +419 0 0 0 +420 0 0 0 +421 0 0 0 +422 0 0 0 +423 0 0 0 +424 0 0 0 +425 0 0 0 +426 0 0 0 +427 0 0 0 +428 0 0 0 +429 0 0 0 +430 0 0 0 +431 0 0 0 +432 0 0 0 +433 0 0 0 +434 0 0 0 +435 0 0 0 +436 0 0 0 +437 0 0 0 +438 0 0 0 +439 0 0 0 +440 0 0 0 +441 0 0 0 +442 0 0 0 +443 0 0 0 +444 0 0 0 +445 0 0 0 +446 0 0 0 +447 0 0 0 +448 0 0 0 +449 0 0 0 +450 0 0 0 +451 0 0 0 +452 0 0 0 +453 0 0 0 +454 0 0 0 +455 0 0 0 +456 0 0 0 +457 0 0 0 +458 0 0 0 +459 0 0 0 +460 0 0 0 +461 0 0 0 +462 0 0 0 +463 0 0 0 +464 0 0 0 +465 0 0 0 +466 0 0 0 +467 0 0 0 +468 0 0 0 +469 0 0 0 +470 0 0 0 +471 0 0 0 +472 0 0 0 +473 0 0 0 +474 0 0 0 +475 0 0 0 +476 0 0 0 +477 0 0 0 +478 0 0 0 +479 0 0 0 +480 0 0 0 +481 0 0 0 +482 0 0 0 +483 0 0 0 +484 0 0 0 +485 0 0 0 +486 0 0 0 +487 0 0 0 +488 0 0 0 +489 0 0 0 +490 0 0 0 +491 0 0 0 +492 0 0 0 +493 0 0 0 +494 0 0 0 +495 0 0 0 +496 0 0 0 +497 0 0 0 +498 0 0 0 +499 0 0 0 +500 0 0 0 diff --git a/examples/mdi/data.snapshot b/examples/mdi/data.snapshot new file mode 100644 index 0000000000..0bf550ef61 --- /dev/null +++ b/examples/mdi/data.snapshot @@ -0,0 +1,1018 @@ +LAMMPS data file via write_data, version 2 Jun 2022, timestep = 0 + +500 atoms +1 atom types + +0 8.397980956912537 xlo xhi +0 8.397980956912537 ylo yhi +0 8.397980956912537 zlo zhi + +Masses + +1 1 + +Atoms # atomic + +1 1 0 0 0 0 0 0 +2 1 0.8397980956912536 0.8397980956912536 0 0 0 0 +3 1 0.8397980956912536 0 0.8397980956912536 0 0 0 +4 1 0 0.8397980956912536 0.8397980956912536 0 0 0 +5 1 1.6795961913825073 0 0 0 0 0 +6 1 2.519394287073761 0.8397980956912536 0 0 0 0 +7 1 2.519394287073761 0 0.8397980956912536 0 0 0 +8 1 1.6795961913825073 0.8397980956912536 0.8397980956912536 0 0 0 +9 1 3.3591923827650145 0 0 0 0 0 +10 1 4.198990478456269 0.8397980956912536 0 0 0 0 +11 1 4.198990478456269 0 0.8397980956912536 0 0 0 +12 1 3.3591923827650145 0.8397980956912536 0.8397980956912536 0 0 0 +13 1 5.038788574147522 0 0 0 0 0 +14 1 5.878586669838775 0.8397980956912536 0 0 0 0 +15 1 5.878586669838775 0 0.8397980956912536 0 0 0 +16 1 5.038788574147522 0.8397980956912536 0.8397980956912536 0 0 0 +17 1 6.718384765530029 0 0 0 0 0 +18 1 7.558182861221283 0.8397980956912536 0 0 0 0 +19 1 7.558182861221283 0 0.8397980956912536 0 0 0 +20 1 6.718384765530029 0.8397980956912536 0.8397980956912536 0 0 0 +21 1 0 1.6795961913825073 0 0 0 0 +22 1 0.8397980956912536 2.519394287073761 0 0 0 0 +23 1 0.8397980956912536 1.6795961913825073 0.8397980956912536 0 0 0 +24 1 0 2.519394287073761 0.8397980956912536 0 0 0 +25 1 1.6795961913825073 1.6795961913825073 0 0 0 0 +26 1 2.519394287073761 2.519394287073761 0 0 0 0 +27 1 2.519394287073761 1.6795961913825073 0.8397980956912536 0 0 0 +28 1 1.6795961913825073 2.519394287073761 0.8397980956912536 0 0 0 +29 1 3.3591923827650145 1.6795961913825073 0 0 0 0 +30 1 4.198990478456269 2.519394287073761 0 0 0 0 +31 1 4.198990478456269 1.6795961913825073 0.8397980956912536 0 0 0 +32 1 3.3591923827650145 2.519394287073761 0.8397980956912536 0 0 0 +33 1 5.038788574147522 1.6795961913825073 0 0 0 0 +34 1 5.878586669838775 2.519394287073761 0 0 0 0 +35 1 5.878586669838775 1.6795961913825073 0.8397980956912536 0 0 0 +36 1 5.038788574147522 2.519394287073761 0.8397980956912536 0 0 0 +37 1 6.718384765530029 1.6795961913825073 0 0 0 0 +38 1 7.558182861221283 2.519394287073761 0 0 0 0 +39 1 7.558182861221283 1.6795961913825073 0.8397980956912536 0 0 0 +40 1 6.718384765530029 2.519394287073761 0.8397980956912536 0 0 0 +41 1 0 3.3591923827650145 0 0 0 0 +42 1 0.8397980956912536 4.198990478456269 0 0 0 0 +43 1 0.8397980956912536 3.3591923827650145 0.8397980956912536 0 0 0 +44 1 0 4.198990478456269 0.8397980956912536 0 0 0 +45 1 1.6795961913825073 3.3591923827650145 0 0 0 0 +46 1 2.519394287073761 4.198990478456269 0 0 0 0 +47 1 2.519394287073761 3.3591923827650145 0.8397980956912536 0 0 0 +48 1 1.6795961913825073 4.198990478456269 0.8397980956912536 0 0 0 +49 1 3.3591923827650145 3.3591923827650145 0 0 0 0 +50 1 4.198990478456269 4.198990478456269 0 0 0 0 +51 1 4.198990478456269 3.3591923827650145 0.8397980956912536 0 0 0 +52 1 3.3591923827650145 4.198990478456269 0.8397980956912536 0 0 0 +53 1 5.038788574147522 3.3591923827650145 0 0 0 0 +54 1 5.878586669838775 4.198990478456269 0 0 0 0 +55 1 5.878586669838775 3.3591923827650145 0.8397980956912536 0 0 0 +56 1 5.038788574147522 4.198990478456269 0.8397980956912536 0 0 0 +57 1 6.718384765530029 3.3591923827650145 0 0 0 0 +58 1 7.558182861221283 4.198990478456269 0 0 0 0 +59 1 7.558182861221283 3.3591923827650145 0.8397980956912536 0 0 0 +60 1 6.718384765530029 4.198990478456269 0.8397980956912536 0 0 0 +61 1 0 5.038788574147522 0 0 0 0 +62 1 0.8397980956912536 5.878586669838775 0 0 0 0 +63 1 0.8397980956912536 5.038788574147522 0.8397980956912536 0 0 0 +64 1 0 5.878586669838775 0.8397980956912536 0 0 0 +65 1 1.6795961913825073 5.038788574147522 0 0 0 0 +66 1 2.519394287073761 5.878586669838775 0 0 0 0 +67 1 2.519394287073761 5.038788574147522 0.8397980956912536 0 0 0 +68 1 1.6795961913825073 5.878586669838775 0.8397980956912536 0 0 0 +69 1 3.3591923827650145 5.038788574147522 0 0 0 0 +70 1 4.198990478456269 5.878586669838775 0 0 0 0 +71 1 4.198990478456269 5.038788574147522 0.8397980956912536 0 0 0 +72 1 3.3591923827650145 5.878586669838775 0.8397980956912536 0 0 0 +73 1 5.038788574147522 5.038788574147522 0 0 0 0 +74 1 5.878586669838775 5.878586669838775 0 0 0 0 +75 1 5.878586669838775 5.038788574147522 0.8397980956912536 0 0 0 +76 1 5.038788574147522 5.878586669838775 0.8397980956912536 0 0 0 +77 1 6.718384765530029 5.038788574147522 0 0 0 0 +78 1 7.558182861221283 5.878586669838775 0 0 0 0 +79 1 7.558182861221283 5.038788574147522 0.8397980956912536 0 0 0 +80 1 6.718384765530029 5.878586669838775 0.8397980956912536 0 0 0 +81 1 0 6.718384765530029 0 0 0 0 +82 1 0.8397980956912536 7.558182861221283 0 0 0 0 +83 1 0.8397980956912536 6.718384765530029 0.8397980956912536 0 0 0 +84 1 0 7.558182861221283 0.8397980956912536 0 0 0 +85 1 1.6795961913825073 6.718384765530029 0 0 0 0 +86 1 2.519394287073761 7.558182861221283 0 0 0 0 +87 1 2.519394287073761 6.718384765530029 0.8397980956912536 0 0 0 +88 1 1.6795961913825073 7.558182861221283 0.8397980956912536 0 0 0 +89 1 3.3591923827650145 6.718384765530029 0 0 0 0 +90 1 4.198990478456269 7.558182861221283 0 0 0 0 +91 1 4.198990478456269 6.718384765530029 0.8397980956912536 0 0 0 +92 1 3.3591923827650145 7.558182861221283 0.8397980956912536 0 0 0 +93 1 5.038788574147522 6.718384765530029 0 0 0 0 +94 1 5.878586669838775 7.558182861221283 0 0 0 0 +95 1 5.878586669838775 6.718384765530029 0.8397980956912536 0 0 0 +96 1 5.038788574147522 7.558182861221283 0.8397980956912536 0 0 0 +97 1 6.718384765530029 6.718384765530029 0 0 0 0 +98 1 7.558182861221283 7.558182861221283 0 0 0 0 +99 1 7.558182861221283 6.718384765530029 0.8397980956912536 0 0 0 +100 1 6.718384765530029 7.558182861221283 0.8397980956912536 0 0 0 +101 1 0 0 1.6795961913825073 0 0 0 +102 1 0.8397980956912536 0.8397980956912536 1.6795961913825073 0 0 0 +103 1 0.8397980956912536 0 2.519394287073761 0 0 0 +104 1 0 0.8397980956912536 2.519394287073761 0 0 0 +105 1 1.6795961913825073 0 1.6795961913825073 0 0 0 +106 1 2.519394287073761 0.8397980956912536 1.6795961913825073 0 0 0 +107 1 2.519394287073761 0 2.519394287073761 0 0 0 +108 1 1.6795961913825073 0.8397980956912536 2.519394287073761 0 0 0 +109 1 3.3591923827650145 0 1.6795961913825073 0 0 0 +110 1 4.198990478456269 0.8397980956912536 1.6795961913825073 0 0 0 +111 1 4.198990478456269 0 2.519394287073761 0 0 0 +112 1 3.3591923827650145 0.8397980956912536 2.519394287073761 0 0 0 +113 1 5.038788574147522 0 1.6795961913825073 0 0 0 +114 1 5.878586669838775 0.8397980956912536 1.6795961913825073 0 0 0 +115 1 5.878586669838775 0 2.519394287073761 0 0 0 +116 1 5.038788574147522 0.8397980956912536 2.519394287073761 0 0 0 +117 1 6.718384765530029 0 1.6795961913825073 0 0 0 +118 1 7.558182861221283 0.8397980956912536 1.6795961913825073 0 0 0 +119 1 7.558182861221283 0 2.519394287073761 0 0 0 +120 1 6.718384765530029 0.8397980956912536 2.519394287073761 0 0 0 +121 1 0 1.6795961913825073 1.6795961913825073 0 0 0 +122 1 0.8397980956912536 2.519394287073761 1.6795961913825073 0 0 0 +123 1 0.8397980956912536 1.6795961913825073 2.519394287073761 0 0 0 +124 1 0 2.519394287073761 2.519394287073761 0 0 0 +125 1 1.6795961913825073 1.6795961913825073 1.6795961913825073 0 0 0 +126 1 2.519394287073761 2.519394287073761 1.6795961913825073 0 0 0 +127 1 2.519394287073761 1.6795961913825073 2.519394287073761 0 0 0 +128 1 1.6795961913825073 2.519394287073761 2.519394287073761 0 0 0 +129 1 3.3591923827650145 1.6795961913825073 1.6795961913825073 0 0 0 +130 1 4.198990478456269 2.519394287073761 1.6795961913825073 0 0 0 +131 1 4.198990478456269 1.6795961913825073 2.519394287073761 0 0 0 +132 1 3.3591923827650145 2.519394287073761 2.519394287073761 0 0 0 +133 1 5.038788574147522 1.6795961913825073 1.6795961913825073 0 0 0 +134 1 5.878586669838775 2.519394287073761 1.6795961913825073 0 0 0 +135 1 5.878586669838775 1.6795961913825073 2.519394287073761 0 0 0 +136 1 5.038788574147522 2.519394287073761 2.519394287073761 0 0 0 +137 1 6.718384765530029 1.6795961913825073 1.6795961913825073 0 0 0 +138 1 7.558182861221283 2.519394287073761 1.6795961913825073 0 0 0 +139 1 7.558182861221283 1.6795961913825073 2.519394287073761 0 0 0 +140 1 6.718384765530029 2.519394287073761 2.519394287073761 0 0 0 +141 1 0 3.3591923827650145 1.6795961913825073 0 0 0 +142 1 0.8397980956912536 4.198990478456269 1.6795961913825073 0 0 0 +143 1 0.8397980956912536 3.3591923827650145 2.519394287073761 0 0 0 +144 1 0 4.198990478456269 2.519394287073761 0 0 0 +145 1 1.6795961913825073 3.3591923827650145 1.6795961913825073 0 0 0 +146 1 2.519394287073761 4.198990478456269 1.6795961913825073 0 0 0 +147 1 2.519394287073761 3.3591923827650145 2.519394287073761 0 0 0 +148 1 1.6795961913825073 4.198990478456269 2.519394287073761 0 0 0 +149 1 3.3591923827650145 3.3591923827650145 1.6795961913825073 0 0 0 +150 1 4.198990478456269 4.198990478456269 1.6795961913825073 0 0 0 +151 1 4.198990478456269 3.3591923827650145 2.519394287073761 0 0 0 +152 1 3.3591923827650145 4.198990478456269 2.519394287073761 0 0 0 +153 1 5.038788574147522 3.3591923827650145 1.6795961913825073 0 0 0 +154 1 5.878586669838775 4.198990478456269 1.6795961913825073 0 0 0 +155 1 5.878586669838775 3.3591923827650145 2.519394287073761 0 0 0 +156 1 5.038788574147522 4.198990478456269 2.519394287073761 0 0 0 +157 1 6.718384765530029 3.3591923827650145 1.6795961913825073 0 0 0 +158 1 7.558182861221283 4.198990478456269 1.6795961913825073 0 0 0 +159 1 7.558182861221283 3.3591923827650145 2.519394287073761 0 0 0 +160 1 6.718384765530029 4.198990478456269 2.519394287073761 0 0 0 +161 1 0 5.038788574147522 1.6795961913825073 0 0 0 +162 1 0.8397980956912536 5.878586669838775 1.6795961913825073 0 0 0 +163 1 0.8397980956912536 5.038788574147522 2.519394287073761 0 0 0 +164 1 0 5.878586669838775 2.519394287073761 0 0 0 +165 1 1.6795961913825073 5.038788574147522 1.6795961913825073 0 0 0 +166 1 2.519394287073761 5.878586669838775 1.6795961913825073 0 0 0 +167 1 2.519394287073761 5.038788574147522 2.519394287073761 0 0 0 +168 1 1.6795961913825073 5.878586669838775 2.519394287073761 0 0 0 +169 1 3.3591923827650145 5.038788574147522 1.6795961913825073 0 0 0 +170 1 4.198990478456269 5.878586669838775 1.6795961913825073 0 0 0 +171 1 4.198990478456269 5.038788574147522 2.519394287073761 0 0 0 +172 1 3.3591923827650145 5.878586669838775 2.519394287073761 0 0 0 +173 1 5.038788574147522 5.038788574147522 1.6795961913825073 0 0 0 +174 1 5.878586669838775 5.878586669838775 1.6795961913825073 0 0 0 +175 1 5.878586669838775 5.038788574147522 2.519394287073761 0 0 0 +176 1 5.038788574147522 5.878586669838775 2.519394287073761 0 0 0 +177 1 6.718384765530029 5.038788574147522 1.6795961913825073 0 0 0 +178 1 7.558182861221283 5.878586669838775 1.6795961913825073 0 0 0 +179 1 7.558182861221283 5.038788574147522 2.519394287073761 0 0 0 +180 1 6.718384765530029 5.878586669838775 2.519394287073761 0 0 0 +181 1 0 6.718384765530029 1.6795961913825073 0 0 0 +182 1 0.8397980956912536 7.558182861221283 1.6795961913825073 0 0 0 +183 1 0.8397980956912536 6.718384765530029 2.519394287073761 0 0 0 +184 1 0 7.558182861221283 2.519394287073761 0 0 0 +185 1 1.6795961913825073 6.718384765530029 1.6795961913825073 0 0 0 +186 1 2.519394287073761 7.558182861221283 1.6795961913825073 0 0 0 +187 1 2.519394287073761 6.718384765530029 2.519394287073761 0 0 0 +188 1 1.6795961913825073 7.558182861221283 2.519394287073761 0 0 0 +189 1 3.3591923827650145 6.718384765530029 1.6795961913825073 0 0 0 +190 1 4.198990478456269 7.558182861221283 1.6795961913825073 0 0 0 +191 1 4.198990478456269 6.718384765530029 2.519394287073761 0 0 0 +192 1 3.3591923827650145 7.558182861221283 2.519394287073761 0 0 0 +193 1 5.038788574147522 6.718384765530029 1.6795961913825073 0 0 0 +194 1 5.878586669838775 7.558182861221283 1.6795961913825073 0 0 0 +195 1 5.878586669838775 6.718384765530029 2.519394287073761 0 0 0 +196 1 5.038788574147522 7.558182861221283 2.519394287073761 0 0 0 +197 1 6.718384765530029 6.718384765530029 1.6795961913825073 0 0 0 +198 1 7.558182861221283 7.558182861221283 1.6795961913825073 0 0 0 +199 1 7.558182861221283 6.718384765530029 2.519394287073761 0 0 0 +200 1 6.718384765530029 7.558182861221283 2.519394287073761 0 0 0 +201 1 0 0 3.3591923827650145 0 0 0 +202 1 0.8397980956912536 0.8397980956912536 3.3591923827650145 0 0 0 +203 1 0.8397980956912536 0 4.198990478456269 0 0 0 +204 1 0 0.8397980956912536 4.198990478456269 0 0 0 +205 1 1.6795961913825073 0 3.3591923827650145 0 0 0 +206 1 2.519394287073761 0.8397980956912536 3.3591923827650145 0 0 0 +207 1 2.519394287073761 0 4.198990478456269 0 0 0 +208 1 1.6795961913825073 0.8397980956912536 4.198990478456269 0 0 0 +209 1 3.3591923827650145 0 3.3591923827650145 0 0 0 +210 1 4.198990478456269 0.8397980956912536 3.3591923827650145 0 0 0 +211 1 4.198990478456269 0 4.198990478456269 0 0 0 +212 1 3.3591923827650145 0.8397980956912536 4.198990478456269 0 0 0 +213 1 5.038788574147522 0 3.3591923827650145 0 0 0 +214 1 5.878586669838775 0.8397980956912536 3.3591923827650145 0 0 0 +215 1 5.878586669838775 0 4.198990478456269 0 0 0 +216 1 5.038788574147522 0.8397980956912536 4.198990478456269 0 0 0 +217 1 6.718384765530029 0 3.3591923827650145 0 0 0 +218 1 7.558182861221283 0.8397980956912536 3.3591923827650145 0 0 0 +219 1 7.558182861221283 0 4.198990478456269 0 0 0 +220 1 6.718384765530029 0.8397980956912536 4.198990478456269 0 0 0 +221 1 0 1.6795961913825073 3.3591923827650145 0 0 0 +222 1 0.8397980956912536 2.519394287073761 3.3591923827650145 0 0 0 +223 1 0.8397980956912536 1.6795961913825073 4.198990478456269 0 0 0 +224 1 0 2.519394287073761 4.198990478456269 0 0 0 +225 1 1.6795961913825073 1.6795961913825073 3.3591923827650145 0 0 0 +226 1 2.519394287073761 2.519394287073761 3.3591923827650145 0 0 0 +227 1 2.519394287073761 1.6795961913825073 4.198990478456269 0 0 0 +228 1 1.6795961913825073 2.519394287073761 4.198990478456269 0 0 0 +229 1 3.3591923827650145 1.6795961913825073 3.3591923827650145 0 0 0 +230 1 4.198990478456269 2.519394287073761 3.3591923827650145 0 0 0 +231 1 4.198990478456269 1.6795961913825073 4.198990478456269 0 0 0 +232 1 3.3591923827650145 2.519394287073761 4.198990478456269 0 0 0 +233 1 5.038788574147522 1.6795961913825073 3.3591923827650145 0 0 0 +234 1 5.878586669838775 2.519394287073761 3.3591923827650145 0 0 0 +235 1 5.878586669838775 1.6795961913825073 4.198990478456269 0 0 0 +236 1 5.038788574147522 2.519394287073761 4.198990478456269 0 0 0 +237 1 6.718384765530029 1.6795961913825073 3.3591923827650145 0 0 0 +238 1 7.558182861221283 2.519394287073761 3.3591923827650145 0 0 0 +239 1 7.558182861221283 1.6795961913825073 4.198990478456269 0 0 0 +240 1 6.718384765530029 2.519394287073761 4.198990478456269 0 0 0 +241 1 0 3.3591923827650145 3.3591923827650145 0 0 0 +242 1 0.8397980956912536 4.198990478456269 3.3591923827650145 0 0 0 +243 1 0.8397980956912536 3.3591923827650145 4.198990478456269 0 0 0 +244 1 0 4.198990478456269 4.198990478456269 0 0 0 +245 1 1.6795961913825073 3.3591923827650145 3.3591923827650145 0 0 0 +246 1 2.519394287073761 4.198990478456269 3.3591923827650145 0 0 0 +247 1 2.519394287073761 3.3591923827650145 4.198990478456269 0 0 0 +248 1 1.6795961913825073 4.198990478456269 4.198990478456269 0 0 0 +249 1 3.3591923827650145 3.3591923827650145 3.3591923827650145 0 0 0 +250 1 4.198990478456269 4.198990478456269 3.3591923827650145 0 0 0 +251 1 4.198990478456269 3.3591923827650145 4.198990478456269 0 0 0 +252 1 3.3591923827650145 4.198990478456269 4.198990478456269 0 0 0 +253 1 5.038788574147522 3.3591923827650145 3.3591923827650145 0 0 0 +254 1 5.878586669838775 4.198990478456269 3.3591923827650145 0 0 0 +255 1 5.878586669838775 3.3591923827650145 4.198990478456269 0 0 0 +256 1 5.038788574147522 4.198990478456269 4.198990478456269 0 0 0 +257 1 6.718384765530029 3.3591923827650145 3.3591923827650145 0 0 0 +258 1 7.558182861221283 4.198990478456269 3.3591923827650145 0 0 0 +259 1 7.558182861221283 3.3591923827650145 4.198990478456269 0 0 0 +260 1 6.718384765530029 4.198990478456269 4.198990478456269 0 0 0 +261 1 0 5.038788574147522 3.3591923827650145 0 0 0 +262 1 0.8397980956912536 5.878586669838775 3.3591923827650145 0 0 0 +263 1 0.8397980956912536 5.038788574147522 4.198990478456269 0 0 0 +264 1 0 5.878586669838775 4.198990478456269 0 0 0 +265 1 1.6795961913825073 5.038788574147522 3.3591923827650145 0 0 0 +266 1 2.519394287073761 5.878586669838775 3.3591923827650145 0 0 0 +267 1 2.519394287073761 5.038788574147522 4.198990478456269 0 0 0 +268 1 1.6795961913825073 5.878586669838775 4.198990478456269 0 0 0 +269 1 3.3591923827650145 5.038788574147522 3.3591923827650145 0 0 0 +270 1 4.198990478456269 5.878586669838775 3.3591923827650145 0 0 0 +271 1 4.198990478456269 5.038788574147522 4.198990478456269 0 0 0 +272 1 3.3591923827650145 5.878586669838775 4.198990478456269 0 0 0 +273 1 5.038788574147522 5.038788574147522 3.3591923827650145 0 0 0 +274 1 5.878586669838775 5.878586669838775 3.3591923827650145 0 0 0 +275 1 5.878586669838775 5.038788574147522 4.198990478456269 0 0 0 +276 1 5.038788574147522 5.878586669838775 4.198990478456269 0 0 0 +277 1 6.718384765530029 5.038788574147522 3.3591923827650145 0 0 0 +278 1 7.558182861221283 5.878586669838775 3.3591923827650145 0 0 0 +279 1 7.558182861221283 5.038788574147522 4.198990478456269 0 0 0 +280 1 6.718384765530029 5.878586669838775 4.198990478456269 0 0 0 +281 1 0 6.718384765530029 3.3591923827650145 0 0 0 +282 1 0.8397980956912536 7.558182861221283 3.3591923827650145 0 0 0 +283 1 0.8397980956912536 6.718384765530029 4.198990478456269 0 0 0 +284 1 0 7.558182861221283 4.198990478456269 0 0 0 +285 1 1.6795961913825073 6.718384765530029 3.3591923827650145 0 0 0 +286 1 2.519394287073761 7.558182861221283 3.3591923827650145 0 0 0 +287 1 2.519394287073761 6.718384765530029 4.198990478456269 0 0 0 +288 1 1.6795961913825073 7.558182861221283 4.198990478456269 0 0 0 +289 1 3.3591923827650145 6.718384765530029 3.3591923827650145 0 0 0 +290 1 4.198990478456269 7.558182861221283 3.3591923827650145 0 0 0 +291 1 4.198990478456269 6.718384765530029 4.198990478456269 0 0 0 +292 1 3.3591923827650145 7.558182861221283 4.198990478456269 0 0 0 +293 1 5.038788574147522 6.718384765530029 3.3591923827650145 0 0 0 +294 1 5.878586669838775 7.558182861221283 3.3591923827650145 0 0 0 +295 1 5.878586669838775 6.718384765530029 4.198990478456269 0 0 0 +296 1 5.038788574147522 7.558182861221283 4.198990478456269 0 0 0 +297 1 6.718384765530029 6.718384765530029 3.3591923827650145 0 0 0 +298 1 7.558182861221283 7.558182861221283 3.3591923827650145 0 0 0 +299 1 7.558182861221283 6.718384765530029 4.198990478456269 0 0 0 +300 1 6.718384765530029 7.558182861221283 4.198990478456269 0 0 0 +301 1 0 0 5.038788574147522 0 0 0 +302 1 0.8397980956912536 0.8397980956912536 5.038788574147522 0 0 0 +303 1 0.8397980956912536 0 5.878586669838775 0 0 0 +304 1 0 0.8397980956912536 5.878586669838775 0 0 0 +305 1 1.6795961913825073 0 5.038788574147522 0 0 0 +306 1 2.519394287073761 0.8397980956912536 5.038788574147522 0 0 0 +307 1 2.519394287073761 0 5.878586669838775 0 0 0 +308 1 1.6795961913825073 0.8397980956912536 5.878586669838775 0 0 0 +309 1 3.3591923827650145 0 5.038788574147522 0 0 0 +310 1 4.198990478456269 0.8397980956912536 5.038788574147522 0 0 0 +311 1 4.198990478456269 0 5.878586669838775 0 0 0 +312 1 3.3591923827650145 0.8397980956912536 5.878586669838775 0 0 0 +313 1 5.038788574147522 0 5.038788574147522 0 0 0 +314 1 5.878586669838775 0.8397980956912536 5.038788574147522 0 0 0 +315 1 5.878586669838775 0 5.878586669838775 0 0 0 +316 1 5.038788574147522 0.8397980956912536 5.878586669838775 0 0 0 +317 1 6.718384765530029 0 5.038788574147522 0 0 0 +318 1 7.558182861221283 0.8397980956912536 5.038788574147522 0 0 0 +319 1 7.558182861221283 0 5.878586669838775 0 0 0 +320 1 6.718384765530029 0.8397980956912536 5.878586669838775 0 0 0 +321 1 0 1.6795961913825073 5.038788574147522 0 0 0 +322 1 0.8397980956912536 2.519394287073761 5.038788574147522 0 0 0 +323 1 0.8397980956912536 1.6795961913825073 5.878586669838775 0 0 0 +324 1 0 2.519394287073761 5.878586669838775 0 0 0 +325 1 1.6795961913825073 1.6795961913825073 5.038788574147522 0 0 0 +326 1 2.519394287073761 2.519394287073761 5.038788574147522 0 0 0 +327 1 2.519394287073761 1.6795961913825073 5.878586669838775 0 0 0 +328 1 1.6795961913825073 2.519394287073761 5.878586669838775 0 0 0 +329 1 3.3591923827650145 1.6795961913825073 5.038788574147522 0 0 0 +330 1 4.198990478456269 2.519394287073761 5.038788574147522 0 0 0 +331 1 4.198990478456269 1.6795961913825073 5.878586669838775 0 0 0 +332 1 3.3591923827650145 2.519394287073761 5.878586669838775 0 0 0 +333 1 5.038788574147522 1.6795961913825073 5.038788574147522 0 0 0 +334 1 5.878586669838775 2.519394287073761 5.038788574147522 0 0 0 +335 1 5.878586669838775 1.6795961913825073 5.878586669838775 0 0 0 +336 1 5.038788574147522 2.519394287073761 5.878586669838775 0 0 0 +337 1 6.718384765530029 1.6795961913825073 5.038788574147522 0 0 0 +338 1 7.558182861221283 2.519394287073761 5.038788574147522 0 0 0 +339 1 7.558182861221283 1.6795961913825073 5.878586669838775 0 0 0 +340 1 6.718384765530029 2.519394287073761 5.878586669838775 0 0 0 +341 1 0 3.3591923827650145 5.038788574147522 0 0 0 +342 1 0.8397980956912536 4.198990478456269 5.038788574147522 0 0 0 +343 1 0.8397980956912536 3.3591923827650145 5.878586669838775 0 0 0 +344 1 0 4.198990478456269 5.878586669838775 0 0 0 +345 1 1.6795961913825073 3.3591923827650145 5.038788574147522 0 0 0 +346 1 2.519394287073761 4.198990478456269 5.038788574147522 0 0 0 +347 1 2.519394287073761 3.3591923827650145 5.878586669838775 0 0 0 +348 1 1.6795961913825073 4.198990478456269 5.878586669838775 0 0 0 +349 1 3.3591923827650145 3.3591923827650145 5.038788574147522 0 0 0 +350 1 4.198990478456269 4.198990478456269 5.038788574147522 0 0 0 +351 1 4.198990478456269 3.3591923827650145 5.878586669838775 0 0 0 +352 1 3.3591923827650145 4.198990478456269 5.878586669838775 0 0 0 +353 1 5.038788574147522 3.3591923827650145 5.038788574147522 0 0 0 +354 1 5.878586669838775 4.198990478456269 5.038788574147522 0 0 0 +355 1 5.878586669838775 3.3591923827650145 5.878586669838775 0 0 0 +356 1 5.038788574147522 4.198990478456269 5.878586669838775 0 0 0 +357 1 6.718384765530029 3.3591923827650145 5.038788574147522 0 0 0 +358 1 7.558182861221283 4.198990478456269 5.038788574147522 0 0 0 +359 1 7.558182861221283 3.3591923827650145 5.878586669838775 0 0 0 +360 1 6.718384765530029 4.198990478456269 5.878586669838775 0 0 0 +361 1 0 5.038788574147522 5.038788574147522 0 0 0 +362 1 0.8397980956912536 5.878586669838775 5.038788574147522 0 0 0 +363 1 0.8397980956912536 5.038788574147522 5.878586669838775 0 0 0 +364 1 0 5.878586669838775 5.878586669838775 0 0 0 +365 1 1.6795961913825073 5.038788574147522 5.038788574147522 0 0 0 +366 1 2.519394287073761 5.878586669838775 5.038788574147522 0 0 0 +367 1 2.519394287073761 5.038788574147522 5.878586669838775 0 0 0 +368 1 1.6795961913825073 5.878586669838775 5.878586669838775 0 0 0 +369 1 3.3591923827650145 5.038788574147522 5.038788574147522 0 0 0 +370 1 4.198990478456269 5.878586669838775 5.038788574147522 0 0 0 +371 1 4.198990478456269 5.038788574147522 5.878586669838775 0 0 0 +372 1 3.3591923827650145 5.878586669838775 5.878586669838775 0 0 0 +373 1 5.038788574147522 5.038788574147522 5.038788574147522 0 0 0 +374 1 5.878586669838775 5.878586669838775 5.038788574147522 0 0 0 +375 1 5.878586669838775 5.038788574147522 5.878586669838775 0 0 0 +376 1 5.038788574147522 5.878586669838775 5.878586669838775 0 0 0 +377 1 6.718384765530029 5.038788574147522 5.038788574147522 0 0 0 +378 1 7.558182861221283 5.878586669838775 5.038788574147522 0 0 0 +379 1 7.558182861221283 5.038788574147522 5.878586669838775 0 0 0 +380 1 6.718384765530029 5.878586669838775 5.878586669838775 0 0 0 +381 1 0 6.718384765530029 5.038788574147522 0 0 0 +382 1 0.8397980956912536 7.558182861221283 5.038788574147522 0 0 0 +383 1 0.8397980956912536 6.718384765530029 5.878586669838775 0 0 0 +384 1 0 7.558182861221283 5.878586669838775 0 0 0 +385 1 1.6795961913825073 6.718384765530029 5.038788574147522 0 0 0 +386 1 2.519394287073761 7.558182861221283 5.038788574147522 0 0 0 +387 1 2.519394287073761 6.718384765530029 5.878586669838775 0 0 0 +388 1 1.6795961913825073 7.558182861221283 5.878586669838775 0 0 0 +389 1 3.3591923827650145 6.718384765530029 5.038788574147522 0 0 0 +390 1 4.198990478456269 7.558182861221283 5.038788574147522 0 0 0 +391 1 4.198990478456269 6.718384765530029 5.878586669838775 0 0 0 +392 1 3.3591923827650145 7.558182861221283 5.878586669838775 0 0 0 +393 1 5.038788574147522 6.718384765530029 5.038788574147522 0 0 0 +394 1 5.878586669838775 7.558182861221283 5.038788574147522 0 0 0 +395 1 5.878586669838775 6.718384765530029 5.878586669838775 0 0 0 +396 1 5.038788574147522 7.558182861221283 5.878586669838775 0 0 0 +397 1 6.718384765530029 6.718384765530029 5.038788574147522 0 0 0 +398 1 7.558182861221283 7.558182861221283 5.038788574147522 0 0 0 +399 1 7.558182861221283 6.718384765530029 5.878586669838775 0 0 0 +400 1 6.718384765530029 7.558182861221283 5.878586669838775 0 0 0 +401 1 0 0 6.718384765530029 0 0 0 +402 1 0.8397980956912536 0.8397980956912536 6.718384765530029 0 0 0 +403 1 0.8397980956912536 0 7.558182861221283 0 0 0 +404 1 0 0.8397980956912536 7.558182861221283 0 0 0 +405 1 1.6795961913825073 0 6.718384765530029 0 0 0 +406 1 2.519394287073761 0.8397980956912536 6.718384765530029 0 0 0 +407 1 2.519394287073761 0 7.558182861221283 0 0 0 +408 1 1.6795961913825073 0.8397980956912536 7.558182861221283 0 0 0 +409 1 3.3591923827650145 0 6.718384765530029 0 0 0 +410 1 4.198990478456269 0.8397980956912536 6.718384765530029 0 0 0 +411 1 4.198990478456269 0 7.558182861221283 0 0 0 +412 1 3.3591923827650145 0.8397980956912536 7.558182861221283 0 0 0 +413 1 5.038788574147522 0 6.718384765530029 0 0 0 +414 1 5.878586669838775 0.8397980956912536 6.718384765530029 0 0 0 +415 1 5.878586669838775 0 7.558182861221283 0 0 0 +416 1 5.038788574147522 0.8397980956912536 7.558182861221283 0 0 0 +417 1 6.718384765530029 0 6.718384765530029 0 0 0 +418 1 7.558182861221283 0.8397980956912536 6.718384765530029 0 0 0 +419 1 7.558182861221283 0 7.558182861221283 0 0 0 +420 1 6.718384765530029 0.8397980956912536 7.558182861221283 0 0 0 +421 1 0 1.6795961913825073 6.718384765530029 0 0 0 +422 1 0.8397980956912536 2.519394287073761 6.718384765530029 0 0 0 +423 1 0.8397980956912536 1.6795961913825073 7.558182861221283 0 0 0 +424 1 0 2.519394287073761 7.558182861221283 0 0 0 +425 1 1.6795961913825073 1.6795961913825073 6.718384765530029 0 0 0 +426 1 2.519394287073761 2.519394287073761 6.718384765530029 0 0 0 +427 1 2.519394287073761 1.6795961913825073 7.558182861221283 0 0 0 +428 1 1.6795961913825073 2.519394287073761 7.558182861221283 0 0 0 +429 1 3.3591923827650145 1.6795961913825073 6.718384765530029 0 0 0 +430 1 4.198990478456269 2.519394287073761 6.718384765530029 0 0 0 +431 1 4.198990478456269 1.6795961913825073 7.558182861221283 0 0 0 +432 1 3.3591923827650145 2.519394287073761 7.558182861221283 0 0 0 +433 1 5.038788574147522 1.6795961913825073 6.718384765530029 0 0 0 +434 1 5.878586669838775 2.519394287073761 6.718384765530029 0 0 0 +435 1 5.878586669838775 1.6795961913825073 7.558182861221283 0 0 0 +436 1 5.038788574147522 2.519394287073761 7.558182861221283 0 0 0 +437 1 6.718384765530029 1.6795961913825073 6.718384765530029 0 0 0 +438 1 7.558182861221283 2.519394287073761 6.718384765530029 0 0 0 +439 1 7.558182861221283 1.6795961913825073 7.558182861221283 0 0 0 +440 1 6.718384765530029 2.519394287073761 7.558182861221283 0 0 0 +441 1 0 3.3591923827650145 6.718384765530029 0 0 0 +442 1 0.8397980956912536 4.198990478456269 6.718384765530029 0 0 0 +443 1 0.8397980956912536 3.3591923827650145 7.558182861221283 0 0 0 +444 1 0 4.198990478456269 7.558182861221283 0 0 0 +445 1 1.6795961913825073 3.3591923827650145 6.718384765530029 0 0 0 +446 1 2.519394287073761 4.198990478456269 6.718384765530029 0 0 0 +447 1 2.519394287073761 3.3591923827650145 7.558182861221283 0 0 0 +448 1 1.6795961913825073 4.198990478456269 7.558182861221283 0 0 0 +449 1 3.3591923827650145 3.3591923827650145 6.718384765530029 0 0 0 +450 1 4.198990478456269 4.198990478456269 6.718384765530029 0 0 0 +451 1 4.198990478456269 3.3591923827650145 7.558182861221283 0 0 0 +452 1 3.3591923827650145 4.198990478456269 7.558182861221283 0 0 0 +453 1 5.038788574147522 3.3591923827650145 6.718384765530029 0 0 0 +454 1 5.878586669838775 4.198990478456269 6.718384765530029 0 0 0 +455 1 5.878586669838775 3.3591923827650145 7.558182861221283 0 0 0 +456 1 5.038788574147522 4.198990478456269 7.558182861221283 0 0 0 +457 1 6.718384765530029 3.3591923827650145 6.718384765530029 0 0 0 +458 1 7.558182861221283 4.198990478456269 6.718384765530029 0 0 0 +459 1 7.558182861221283 3.3591923827650145 7.558182861221283 0 0 0 +460 1 6.718384765530029 4.198990478456269 7.558182861221283 0 0 0 +461 1 0 5.038788574147522 6.718384765530029 0 0 0 +462 1 0.8397980956912536 5.878586669838775 6.718384765530029 0 0 0 +463 1 0.8397980956912536 5.038788574147522 7.558182861221283 0 0 0 +464 1 0 5.878586669838775 7.558182861221283 0 0 0 +465 1 1.6795961913825073 5.038788574147522 6.718384765530029 0 0 0 +466 1 2.519394287073761 5.878586669838775 6.718384765530029 0 0 0 +467 1 2.519394287073761 5.038788574147522 7.558182861221283 0 0 0 +468 1 1.6795961913825073 5.878586669838775 7.558182861221283 0 0 0 +469 1 3.3591923827650145 5.038788574147522 6.718384765530029 0 0 0 +470 1 4.198990478456269 5.878586669838775 6.718384765530029 0 0 0 +471 1 4.198990478456269 5.038788574147522 7.558182861221283 0 0 0 +472 1 3.3591923827650145 5.878586669838775 7.558182861221283 0 0 0 +473 1 5.038788574147522 5.038788574147522 6.718384765530029 0 0 0 +474 1 5.878586669838775 5.878586669838775 6.718384765530029 0 0 0 +475 1 5.878586669838775 5.038788574147522 7.558182861221283 0 0 0 +476 1 5.038788574147522 5.878586669838775 7.558182861221283 0 0 0 +477 1 6.718384765530029 5.038788574147522 6.718384765530029 0 0 0 +478 1 7.558182861221283 5.878586669838775 6.718384765530029 0 0 0 +479 1 7.558182861221283 5.038788574147522 7.558182861221283 0 0 0 +480 1 6.718384765530029 5.878586669838775 7.558182861221283 0 0 0 +481 1 0 6.718384765530029 6.718384765530029 0 0 0 +482 1 0.8397980956912536 7.558182861221283 6.718384765530029 0 0 0 +483 1 0.8397980956912536 6.718384765530029 7.558182861221283 0 0 0 +484 1 0 7.558182861221283 7.558182861221283 0 0 0 +485 1 1.6795961913825073 6.718384765530029 6.718384765530029 0 0 0 +486 1 2.519394287073761 7.558182861221283 6.718384765530029 0 0 0 +487 1 2.519394287073761 6.718384765530029 7.558182861221283 0 0 0 +488 1 1.6795961913825073 7.558182861221283 7.558182861221283 0 0 0 +489 1 3.3591923827650145 6.718384765530029 6.718384765530029 0 0 0 +490 1 4.198990478456269 7.558182861221283 6.718384765530029 0 0 0 +491 1 4.198990478456269 6.718384765530029 7.558182861221283 0 0 0 +492 1 3.3591923827650145 7.558182861221283 7.558182861221283 0 0 0 +493 1 5.038788574147522 6.718384765530029 6.718384765530029 0 0 0 +494 1 5.878586669838775 7.558182861221283 6.718384765530029 0 0 0 +495 1 5.878586669838775 6.718384765530029 7.558182861221283 0 0 0 +496 1 5.038788574147522 7.558182861221283 7.558182861221283 0 0 0 +497 1 6.718384765530029 6.718384765530029 6.718384765530029 0 0 0 +498 1 7.558182861221283 7.558182861221283 6.718384765530029 0 0 0 +499 1 7.558182861221283 6.718384765530029 7.558182861221283 0 0 0 +500 1 6.718384765530029 7.558182861221283 7.558182861221283 0 0 0 + +Velocities + +1 0 0 0 +2 0 0 0 +3 0 0 0 +4 0 0 0 +5 0 0 0 +6 0 0 0 +7 0 0 0 +8 0 0 0 +9 0 0 0 +10 0 0 0 +11 0 0 0 +12 0 0 0 +13 0 0 0 +14 0 0 0 +15 0 0 0 +16 0 0 0 +17 0 0 0 +18 0 0 0 +19 0 0 0 +20 0 0 0 +21 0 0 0 +22 0 0 0 +23 0 0 0 +24 0 0 0 +25 0 0 0 +26 0 0 0 +27 0 0 0 +28 0 0 0 +29 0 0 0 +30 0 0 0 +31 0 0 0 +32 0 0 0 +33 0 0 0 +34 0 0 0 +35 0 0 0 +36 0 0 0 +37 0 0 0 +38 0 0 0 +39 0 0 0 +40 0 0 0 +41 0 0 0 +42 0 0 0 +43 0 0 0 +44 0 0 0 +45 0 0 0 +46 0 0 0 +47 0 0 0 +48 0 0 0 +49 0 0 0 +50 0 0 0 +51 0 0 0 +52 0 0 0 +53 0 0 0 +54 0 0 0 +55 0 0 0 +56 0 0 0 +57 0 0 0 +58 0 0 0 +59 0 0 0 +60 0 0 0 +61 0 0 0 +62 0 0 0 +63 0 0 0 +64 0 0 0 +65 0 0 0 +66 0 0 0 +67 0 0 0 +68 0 0 0 +69 0 0 0 +70 0 0 0 +71 0 0 0 +72 0 0 0 +73 0 0 0 +74 0 0 0 +75 0 0 0 +76 0 0 0 +77 0 0 0 +78 0 0 0 +79 0 0 0 +80 0 0 0 +81 0 0 0 +82 0 0 0 +83 0 0 0 +84 0 0 0 +85 0 0 0 +86 0 0 0 +87 0 0 0 +88 0 0 0 +89 0 0 0 +90 0 0 0 +91 0 0 0 +92 0 0 0 +93 0 0 0 +94 0 0 0 +95 0 0 0 +96 0 0 0 +97 0 0 0 +98 0 0 0 +99 0 0 0 +100 0 0 0 +101 0 0 0 +102 0 0 0 +103 0 0 0 +104 0 0 0 +105 0 0 0 +106 0 0 0 +107 0 0 0 +108 0 0 0 +109 0 0 0 +110 0 0 0 +111 0 0 0 +112 0 0 0 +113 0 0 0 +114 0 0 0 +115 0 0 0 +116 0 0 0 +117 0 0 0 +118 0 0 0 +119 0 0 0 +120 0 0 0 +121 0 0 0 +122 0 0 0 +123 0 0 0 +124 0 0 0 +125 0 0 0 +126 0 0 0 +127 0 0 0 +128 0 0 0 +129 0 0 0 +130 0 0 0 +131 0 0 0 +132 0 0 0 +133 0 0 0 +134 0 0 0 +135 0 0 0 +136 0 0 0 +137 0 0 0 +138 0 0 0 +139 0 0 0 +140 0 0 0 +141 0 0 0 +142 0 0 0 +143 0 0 0 +144 0 0 0 +145 0 0 0 +146 0 0 0 +147 0 0 0 +148 0 0 0 +149 0 0 0 +150 0 0 0 +151 0 0 0 +152 0 0 0 +153 0 0 0 +154 0 0 0 +155 0 0 0 +156 0 0 0 +157 0 0 0 +158 0 0 0 +159 0 0 0 +160 0 0 0 +161 0 0 0 +162 0 0 0 +163 0 0 0 +164 0 0 0 +165 0 0 0 +166 0 0 0 +167 0 0 0 +168 0 0 0 +169 0 0 0 +170 0 0 0 +171 0 0 0 +172 0 0 0 +173 0 0 0 +174 0 0 0 +175 0 0 0 +176 0 0 0 +177 0 0 0 +178 0 0 0 +179 0 0 0 +180 0 0 0 +181 0 0 0 +182 0 0 0 +183 0 0 0 +184 0 0 0 +185 0 0 0 +186 0 0 0 +187 0 0 0 +188 0 0 0 +189 0 0 0 +190 0 0 0 +191 0 0 0 +192 0 0 0 +193 0 0 0 +194 0 0 0 +195 0 0 0 +196 0 0 0 +197 0 0 0 +198 0 0 0 +199 0 0 0 +200 0 0 0 +201 0 0 0 +202 0 0 0 +203 0 0 0 +204 0 0 0 +205 0 0 0 +206 0 0 0 +207 0 0 0 +208 0 0 0 +209 0 0 0 +210 0 0 0 +211 0 0 0 +212 0 0 0 +213 0 0 0 +214 0 0 0 +215 0 0 0 +216 0 0 0 +217 0 0 0 +218 0 0 0 +219 0 0 0 +220 0 0 0 +221 0 0 0 +222 0 0 0 +223 0 0 0 +224 0 0 0 +225 0 0 0 +226 0 0 0 +227 0 0 0 +228 0 0 0 +229 0 0 0 +230 0 0 0 +231 0 0 0 +232 0 0 0 +233 0 0 0 +234 0 0 0 +235 0 0 0 +236 0 0 0 +237 0 0 0 +238 0 0 0 +239 0 0 0 +240 0 0 0 +241 0 0 0 +242 0 0 0 +243 0 0 0 +244 0 0 0 +245 0 0 0 +246 0 0 0 +247 0 0 0 +248 0 0 0 +249 0 0 0 +250 0 0 0 +251 0 0 0 +252 0 0 0 +253 0 0 0 +254 0 0 0 +255 0 0 0 +256 0 0 0 +257 0 0 0 +258 0 0 0 +259 0 0 0 +260 0 0 0 +261 0 0 0 +262 0 0 0 +263 0 0 0 +264 0 0 0 +265 0 0 0 +266 0 0 0 +267 0 0 0 +268 0 0 0 +269 0 0 0 +270 0 0 0 +271 0 0 0 +272 0 0 0 +273 0 0 0 +274 0 0 0 +275 0 0 0 +276 0 0 0 +277 0 0 0 +278 0 0 0 +279 0 0 0 +280 0 0 0 +281 0 0 0 +282 0 0 0 +283 0 0 0 +284 0 0 0 +285 0 0 0 +286 0 0 0 +287 0 0 0 +288 0 0 0 +289 0 0 0 +290 0 0 0 +291 0 0 0 +292 0 0 0 +293 0 0 0 +294 0 0 0 +295 0 0 0 +296 0 0 0 +297 0 0 0 +298 0 0 0 +299 0 0 0 +300 0 0 0 +301 0 0 0 +302 0 0 0 +303 0 0 0 +304 0 0 0 +305 0 0 0 +306 0 0 0 +307 0 0 0 +308 0 0 0 +309 0 0 0 +310 0 0 0 +311 0 0 0 +312 0 0 0 +313 0 0 0 +314 0 0 0 +315 0 0 0 +316 0 0 0 +317 0 0 0 +318 0 0 0 +319 0 0 0 +320 0 0 0 +321 0 0 0 +322 0 0 0 +323 0 0 0 +324 0 0 0 +325 0 0 0 +326 0 0 0 +327 0 0 0 +328 0 0 0 +329 0 0 0 +330 0 0 0 +331 0 0 0 +332 0 0 0 +333 0 0 0 +334 0 0 0 +335 0 0 0 +336 0 0 0 +337 0 0 0 +338 0 0 0 +339 0 0 0 +340 0 0 0 +341 0 0 0 +342 0 0 0 +343 0 0 0 +344 0 0 0 +345 0 0 0 +346 0 0 0 +347 0 0 0 +348 0 0 0 +349 0 0 0 +350 0 0 0 +351 0 0 0 +352 0 0 0 +353 0 0 0 +354 0 0 0 +355 0 0 0 +356 0 0 0 +357 0 0 0 +358 0 0 0 +359 0 0 0 +360 0 0 0 +361 0 0 0 +362 0 0 0 +363 0 0 0 +364 0 0 0 +365 0 0 0 +366 0 0 0 +367 0 0 0 +368 0 0 0 +369 0 0 0 +370 0 0 0 +371 0 0 0 +372 0 0 0 +373 0 0 0 +374 0 0 0 +375 0 0 0 +376 0 0 0 +377 0 0 0 +378 0 0 0 +379 0 0 0 +380 0 0 0 +381 0 0 0 +382 0 0 0 +383 0 0 0 +384 0 0 0 +385 0 0 0 +386 0 0 0 +387 0 0 0 +388 0 0 0 +389 0 0 0 +390 0 0 0 +391 0 0 0 +392 0 0 0 +393 0 0 0 +394 0 0 0 +395 0 0 0 +396 0 0 0 +397 0 0 0 +398 0 0 0 +399 0 0 0 +400 0 0 0 +401 0 0 0 +402 0 0 0 +403 0 0 0 +404 0 0 0 +405 0 0 0 +406 0 0 0 +407 0 0 0 +408 0 0 0 +409 0 0 0 +410 0 0 0 +411 0 0 0 +412 0 0 0 +413 0 0 0 +414 0 0 0 +415 0 0 0 +416 0 0 0 +417 0 0 0 +418 0 0 0 +419 0 0 0 +420 0 0 0 +421 0 0 0 +422 0 0 0 +423 0 0 0 +424 0 0 0 +425 0 0 0 +426 0 0 0 +427 0 0 0 +428 0 0 0 +429 0 0 0 +430 0 0 0 +431 0 0 0 +432 0 0 0 +433 0 0 0 +434 0 0 0 +435 0 0 0 +436 0 0 0 +437 0 0 0 +438 0 0 0 +439 0 0 0 +440 0 0 0 +441 0 0 0 +442 0 0 0 +443 0 0 0 +444 0 0 0 +445 0 0 0 +446 0 0 0 +447 0 0 0 +448 0 0 0 +449 0 0 0 +450 0 0 0 +451 0 0 0 +452 0 0 0 +453 0 0 0 +454 0 0 0 +455 0 0 0 +456 0 0 0 +457 0 0 0 +458 0 0 0 +459 0 0 0 +460 0 0 0 +461 0 0 0 +462 0 0 0 +463 0 0 0 +464 0 0 0 +465 0 0 0 +466 0 0 0 +467 0 0 0 +468 0 0 0 +469 0 0 0 +470 0 0 0 +471 0 0 0 +472 0 0 0 +473 0 0 0 +474 0 0 0 +475 0 0 0 +476 0 0 0 +477 0 0 0 +478 0 0 0 +479 0 0 0 +480 0 0 0 +481 0 0 0 +482 0 0 0 +483 0 0 0 +484 0 0 0 +485 0 0 0 +486 0 0 0 +487 0 0 0 +488 0 0 0 +489 0 0 0 +490 0 0 0 +491 0 0 0 +492 0 0 0 +493 0 0 0 +494 0 0 0 +495 0 0 0 +496 0 0 0 +497 0 0 0 +498 0 0 0 +499 0 0 0 +500 0 0 0 diff --git a/examples/mdi/in.aimd.alone b/examples/mdi/in.aimd.alone index e2857c5704..9332730af4 100644 --- a/examples/mdi/in.aimd.alone +++ b/examples/mdi/in.aimd.alone @@ -29,4 +29,4 @@ fix 1 all nve thermo_style custom step temp pe etotal press vol thermo 1 -run 5 +run 10 diff --git a/examples/mdi/in.aimd.driver b/examples/mdi/in.aimd.driver index b21826d831..652048b6c4 100644 --- a/examples/mdi/in.aimd.driver +++ b/examples/mdi/in.aimd.driver @@ -28,4 +28,4 @@ fix 2 all mdi/qm virial yes thermo_style custom step temp pe etotal press vol thermo 1 -run 5 +run 10 diff --git a/examples/mdi/in.aimd.driver.plugin b/examples/mdi/in.aimd.driver.plugin index 97514cbcd2..a021f12b07 100644 --- a/examples/mdi/in.aimd.driver.plugin +++ b/examples/mdi/in.aimd.driver.plugin @@ -30,4 +30,4 @@ thermo 1 mdi plugin lammps mdi "-role ENGINE -name LMP2 -method LINK" & infile in.aimd.engine extra "-log log.aimd.engine.plugin" & - command "run 5" + command "run 10" diff --git a/examples/mdi/in.aimd.engine b/examples/mdi/in.aimd.engine index f3293e048d..a64d166a24 100644 --- a/examples/mdi/in.aimd.engine +++ b/examples/mdi/in.aimd.engine @@ -14,4 +14,7 @@ pair_coeff 1 1 1.0 1.0 2.5 neighbor 0.3 bin neigh_modify delay 0 every 1 check yes +thermo_style custom step temp pe etotal press vol +thermo 1 + mdi engine diff --git a/examples/mdi/in.aimd.mm b/examples/mdi/in.aimdpy.mm similarity index 100% rename from examples/mdi/in.aimd.mm rename to examples/mdi/in.aimdpy.mm diff --git a/examples/mdi/in.aimd.qm b/examples/mdi/in.aimdpy.qm similarity index 100% rename from examples/mdi/in.aimd.qm rename to examples/mdi/in.aimdpy.qm diff --git a/examples/mdi/in.series.alone b/examples/mdi/in.series.alone index f359581c50..2e17468507 100644 --- a/examples/mdi/in.series.alone +++ b/examples/mdi/in.series.alone @@ -11,11 +11,7 @@ label LOOP units lj atom_style atomic - lattice fcc ${rho} - region box block 0 $x 0 $y 0 $z - create_box 1 box - create_atoms 1 box - mass 1 1.0 + read_data data.series.${rho} displace_atoms all random 0.1 0.1 0.1 48294 diff --git a/examples/mdi/in.series.driver b/examples/mdi/in.series.driver index 4089dd66ec..267df465fc 100644 --- a/examples/mdi/in.series.driver +++ b/examples/mdi/in.series.driver @@ -13,11 +13,7 @@ label LOOP units lj atom_style atomic - lattice fcc ${rho} - region box block 0 $x 0 $y 0 $z - create_box 1 box - create_atoms 1 box - mass 1 1.0 + read_data data.series.${rho} displace_atoms all random 0.1 0.1 0.1 48294 @@ -25,9 +21,9 @@ label LOOP neigh_modify delay 0 every 1 check yes fix 1 all mdi/qm add no virial yes connect no - variable epress equal (f_1[1]+f_1[2]+f_1[3])/3 + variable evirial equal (f_1[1]+f_1[2]+f_1[3])/3 - thermo_style custom step temp f_1 v_epress f_1[1] f_1[2] f_1[3] + thermo_style custom step temp f_1 v_evirial f_1[1] f_1[2] f_1[3] run 0 diff --git a/examples/mdi/in.series.driver.plugin b/examples/mdi/in.series.driver.plugin index 8096b56886..f1189940b4 100644 --- a/examples/mdi/in.series.driver.plugin +++ b/examples/mdi/in.series.driver.plugin @@ -11,11 +11,7 @@ label LOOP units lj atom_style atomic - lattice fcc ${rho} - region box block 0 $x 0 $y 0 $z - create_box 1 box - create_atoms 1 box - mass 1 1.0 + read_data data.series.${rho} displace_atoms all random 0.1 0.1 0.1 48294 @@ -23,9 +19,9 @@ label LOOP neigh_modify delay 0 every 1 check yes fix 1 all mdi/qm add no virial yes - variable epress equal (f_1[1]+f_1[2]+f_1[3])/3 + variable evirial equal (f_1[1]+f_1[2]+f_1[3])/3 - thermo_style custom step temp f_1 v_epress f_1[1] f_1[2] f_1[3] + thermo_style custom step temp f_1 v_evirial f_1[1] f_1[2] f_1[3] mdi plugin lammps mdi "-role ENGINE -name LMP2 -method LINK" & infile in.series.engine & diff --git a/examples/mdi/in.snapshot.alone b/examples/mdi/in.snapshot.alone index cf9683be3f..7633dcaae3 100644 --- a/examples/mdi/in.snapshot.alone +++ b/examples/mdi/in.snapshot.alone @@ -1,17 +1,9 @@ # 3d Lennard-Jones melt - MDI driver script -variable x index 5 -variable y index 5 -variable z index 5 - units lj atom_style atomic -lattice fcc 0.8442 -region box block 0 $x 0 $y 0 $z -create_box 1 box -create_atoms 1 box -mass 1 1.0 +read_data data.snapshot velocity all create 1.44 87287 loop geom @@ -29,8 +21,8 @@ thermo_style custom step temp pe c_1 c_1[1] c_1[2] c_1[3] thermo 100 -dump 1 all custom 500 dump.snapshot.alone & +dump 1 all custom 100 dump.snapshot.alone & id type x y z fx fy fz dump_modify 1 sort id -run 1500 +run 300 diff --git a/examples/mdi/in.snapshot.driver b/examples/mdi/in.snapshot.driver index 607a52a456..78205efb0f 100644 --- a/examples/mdi/in.snapshot.driver +++ b/examples/mdi/in.snapshot.driver @@ -1,17 +1,9 @@ # 3d Lennard-Jones melt - MDI driver script -variable x index 5 -variable y index 5 -variable z index 5 - units lj atom_style atomic -lattice fcc 0.8442 -region box block 0 $x 0 $y 0 $z -create_box 1 box -create_atoms 1 box -mass 1 1.0 +read_data data.snapshot velocity all create 1.44 87287 loop geom @@ -23,19 +15,19 @@ neigh_modify delay 0 every 1 check yes fix 1 all nve -fix 2 all mdi/qm add no every 500 virial yes +fix 2 all mdi/qm add no every 100 virial yes compute 1 all pressure NULL virial -variable epress equal (f_2[1]+f_2[2]+f_2[3])/3 +variable evirial equal (f_2[1]+f_2[2]+f_2[3])/3 thermo_style custom step temp pe c_1 c_1[1] c_1[2] c_1[3] thermo 100 -dump 1 all custom 500 dump.snapshot.driver & +dump 1 all custom 100 dump.snapshot.driver & id type x y z f_2[1] f_2[2] f_2[3] dump_modify 1 sort id -run 1500 pre no post no every 500 & +run 300 pre no post no every 100 & "print 'QM eng = $(f_2/atoms)'" & - "print 'QM virial = $(v_epress) $(f_2[1]) $(f_2[2]) $(f_2[3])'" + "print 'QM virial = $(v_evirial) $(f_2[1]) $(f_2[2]) $(f_2[3])'" diff --git a/examples/mdi/in.snapshot.driver.plugin b/examples/mdi/in.snapshot.driver.plugin index 2fdca3f6cd..37f0fba2f9 100644 --- a/examples/mdi/in.snapshot.driver.plugin +++ b/examples/mdi/in.snapshot.driver.plugin @@ -7,11 +7,7 @@ variable z index 5 units lj atom_style atomic -lattice fcc 0.8442 -region box block 0 $x 0 $y 0 $z -create_box 1 box -create_atoms 1 box -mass 1 1.0 +read_data data.snapshot velocity all create 1.44 87287 loop geom @@ -23,16 +19,16 @@ neigh_modify delay 0 every 1 check yes fix 1 all nve -fix 2 all mdi/qm add no every 500 virial yes +fix 2 all mdi/qm add no every 100 virial yes compute 1 all pressure NULL virial -variable epress equal (f_2[1]+f_2[2]+f_2[3])/3 +variable evirial equal (f_2[1]+f_2[2]+f_2[3])/3 thermo_style custom step temp pe c_1 c_1[1] c_1[2] c_1[3] thermo 100 -dump 1 all custom 500 dump.snapshot.driver.plugin & +dump 1 all custom 100 dump.snapshot.driver.plugin & id type x y z f_2[1] f_2[2] f_2[3] dump_modify 1 sort id @@ -40,7 +36,7 @@ mdi plugin lammps mdi "-role ENGINE -name LMP2 -method LINK" & infile in.snapshot.engine & extra "-log log.snapshot.engine.plugin" & command """ - run 1500 pre no post no every 500 + run 300 pre no post no every 100 "print 'QM eng = $(f_2/atoms)'" - "print 'QM virial = $(v_epress) $(f_2[1]) $(f_2[2]) $(f_2[3])'" + "print 'QM virial = $(v_evirial) $(f_2[1]) $(f_2[2]) $(f_2[3])'" """ diff --git a/src/MDI/fix_mdi_qm.cpp b/src/MDI/fix_mdi_qm.cpp index 99f23f7e59..0b05263f01 100644 --- a/src/MDI/fix_mdi_qm.cpp +++ b/src/MDI/fix_mdi_qm.cpp @@ -344,11 +344,19 @@ void FixMDIQM::post_force(int vflag) } // optionally set fix->virial - // divide by nprocs so each proc stores a portion + // multiply by volume to make it extensive + // divide by nprocs so each proc stores a portion + // this is b/c ComputePressure expects that as input from a fix + // it will do an MPI_Allreduce and divide by volume if (virialflag && addflag) { + double volume; + if (domain->dimension == 2) + volume = domain->xprd * domain->yprd; + else if (domain->dimension == 3) + volume = domain->xprd * domain->yprd * domain->zprd; for (int i = 0; i < 6; i++) - virial[i] = qm_virial[i]/nprocs; + virial[i] = qm_virial[i]*volume/nprocs; } } From 1f35065afcfd6476a4d33b7aff28f46701311ea9 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Thu, 16 Jun 2022 17:38:57 -0600 Subject: [PATCH 378/585] change to 9 element stress tensor --- examples/mdi/sequence_driver.py | 6 +++--- src/MDI/fix_mdi_qm.cpp | 18 +++++++++++------- src/MDI/fix_mdi_qm.h | 2 +- src/MDI/mdi_engine.cpp | 13 +++++++++---- 4 files changed, 24 insertions(+), 15 deletions(-) diff --git a/examples/mdi/sequence_driver.py b/examples/mdi/sequence_driver.py index b0b26f6d7f..33dcf61b70 100644 --- a/examples/mdi/sequence_driver.py +++ b/examples/mdi/sequence_driver.py @@ -155,7 +155,7 @@ def perform_tasks(world,mdicomm,dummy): # request virial tensor mdi.MDI_Send_command("all(FLERR, "MDI: all(FLERR, "MDI: virial @@ -356,7 +360,7 @@ void FixMDIQM::post_force(int vflag) else if (domain->dimension == 3) volume = domain->xprd * domain->yprd * domain->zprd; for (int i = 0; i < 6; i++) - virial[i] = qm_virial[i]*volume/nprocs; + virial[i] = qm_virial_symmetric[i]*volume/nprocs; } } @@ -382,7 +386,7 @@ double FixMDIQM::compute_scalar() double FixMDIQM::compute_vector(int n) { - return qm_virial[n]; + return qm_virial_symmetric[n]; } /* ---------------------------------------------------------------------- diff --git a/src/MDI/fix_mdi_qm.h b/src/MDI/fix_mdi_qm.h index 2d6f4b0d23..1db6a0cce2 100644 --- a/src/MDI/fix_mdi_qm.h +++ b/src/MDI/fix_mdi_qm.h @@ -47,7 +47,7 @@ class FixMDIQM : public Fix { double qm_energy; int lmpunits; - double qm_virial[6],qm_virial_all[6]; + double qm_virial[9],qm_virial_symmetric[6]; double **fqm; MDI_Comm mdicomm; diff --git a/src/MDI/mdi_engine.cpp b/src/MDI/mdi_engine.cpp index c5fc7e0b50..6a58512cfa 100644 --- a/src/MDI/mdi_engine.cpp +++ b/src/MDI/mdi_engine.cpp @@ -1413,16 +1413,21 @@ void MDIEngine::send_pe() /* ---------------------------------------------------------------------- compute_vector(); - for (int i = 0; i < 6; i++) vtensor[i] = press->vector[i] * lmp2mdi_pressure; + vtensor_full[0] = press->vector[0] * lmp2mdi_pressure; + vtensor_full[4] = press->vector[1] * lmp2mdi_pressure; + vtensor_full[8] = press->vector[2] * lmp2mdi_pressure; + vtensor_full[1] = vtensor_full[3] = press->vector[3] * lmp2mdi_pressure; + vtensor_full[2] = vtensor_full[6] = press->vector[4] * lmp2mdi_pressure; + vtensor_full[5] = vtensor_full[7] = press->vector[5] * lmp2mdi_pressure; - int ierr = MDI_Send(vtensor, 6, MDI_DOUBLE, mdicomm); + int ierr = MDI_Send(vtensor_full, 9, MDI_DOUBLE, mdicomm); if (ierr) error->all(FLERR, "MDI: Date: Thu, 16 Jun 2022 18:20:46 -0600 Subject: [PATCH 379/585] Eliminated problem with unassigned coordinates in grid array --- src/ML-SNAP/compute_sna_grid.cpp | 14 +++++++------- src/compute_grid.cpp | 7 ++++--- src/compute_grid.h | 1 - 3 files changed, 11 insertions(+), 11 deletions(-) diff --git a/src/ML-SNAP/compute_sna_grid.cpp b/src/ML-SNAP/compute_sna_grid.cpp index e96b54e7ed..1d868ba769 100644 --- a/src/ML-SNAP/compute_sna_grid.cpp +++ b/src/ML-SNAP/compute_sna_grid.cpp @@ -242,10 +242,12 @@ void ComputeSNAGrid::compute_array() for (int iz = nzlo; iz <= nzhi; iz++) for (int iy = nylo; iy <= nyhi; iy++) for (int ix = nxlo; ix <= nxhi; ix++) { + double xgrid[3]; const int igrid = iz*(nx*ny) + iy*nx + ix; - const double xtmp = grid[igrid][0]; - const double ytmp = grid[igrid][1]; - const double ztmp = grid[igrid][2]; + grid2x(igrid, xgrid); + const double xtmp = xgrid[0]; + const double ytmp = xgrid[1]; + const double ztmp = xgrid[2]; // currently, all grid points are type 1 @@ -275,8 +277,6 @@ void ComputeSNAGrid::compute_array() if (chemflag) jelem = map[jtype]; - // printf("jtype = %d cutsq[jtype][jtype] = %g\n", - // jtype, cutsq[jtype][jtype]); if (rsq < cutsq[jtype][jtype] && rsq > 1e-20) { snaptr->rij[ninside][0] = delx; snaptr->rij[ninside][1] = dely; @@ -315,7 +315,7 @@ void ComputeSNAGrid::compute_array() } } - memset(grid[0],0,ngrid*size_array_cols*sizeof(double)); + memset(&grid[0][0],0,size_array_rows*size_array_cols*sizeof(double)); for (int iz = nzlo; iz <= nzhi; iz++) for (int iy = nylo; iy <= nyhi; iy++) @@ -324,7 +324,7 @@ void ComputeSNAGrid::compute_array() for (int j = 0; j < nvalues; j++) grid[igrid][size_array_cols_base + j] = gridlocal[size_array_cols_base + j][iz][iy][ix]; } - MPI_Allreduce(&grid[0][0],&gridall[0][0],ngrid*size_array_cols,MPI_DOUBLE,MPI_SUM,world); + MPI_Allreduce(&grid[0][0],&gridall[0][0],size_array_rows*size_array_cols,MPI_DOUBLE,MPI_SUM,world); assign_coords_all(); } diff --git a/src/compute_grid.cpp b/src/compute_grid.cpp index 91d320bf63..dd21b731e8 100644 --- a/src/compute_grid.cpp +++ b/src/compute_grid.cpp @@ -51,7 +51,7 @@ ComputeGrid::ComputeGrid(LAMMPS *lmp, int narg, char **arg) : nargbase = iarg - iarg0; - size_array_rows = ngrid = nx*ny*nz; + size_array_rows = nx*ny*nz; size_array_cols_base = 3; gridlocal_allocated = 0; } @@ -106,7 +106,7 @@ void ComputeGrid::grid2x(int igrid, double *x) void ComputeGrid::assign_coords_all() { double x[3]; - for (int igrid = 0; igrid < ngrid; igrid++) { + for (int igrid = 0; igrid < size_array_rows; igrid++) { grid2x(igrid,x); gridall[igrid][0] = x[0]; gridall[igrid][1] = x[1]; @@ -122,12 +122,13 @@ void ComputeGrid::allocate() { // allocate arrays + printf("In allocate() %d %d \n", size_array_rows,size_array_cols); memory->create(grid,size_array_rows,size_array_cols,"grid:grid"); memory->create(gridall,size_array_rows,size_array_cols,"grid:gridall"); if (nxlo <= nxhi && nylo <= nyhi && nzlo <= nzhi) { gridlocal_allocated = 1; memory->create4d_offset(gridlocal,size_array_cols,nzlo,nzhi,nylo,nyhi, - nxlo,nxhi,"grid:gridlocal"); + nxlo,nxhi,"grid:gridlocal"); } array = gridall; } diff --git a/src/compute_grid.h b/src/compute_grid.h index ab8e5bbf9e..7bda1a89fa 100644 --- a/src/compute_grid.h +++ b/src/compute_grid.h @@ -32,7 +32,6 @@ class ComputeGrid : public Compute { protected: int nx, ny, nz; // global grid dimensions int nxlo, nxhi, nylo, nyhi, nzlo, nzhi; // local grid bounds, inclusive - int ngrid; // number of global grid points int ngridlocal; // number of local grid points int nvalues; // number of values per grid point double **grid; // global grid From a7c5b5e8fd152f5abe064451b4371a9695834095 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Thu, 16 Jun 2022 20:22:40 -0600 Subject: [PATCH 380/585] Finsished documentation --- doc/src/Commands_compute.rst | 2 + doc/src/Errors_warnings.rst | 6 + doc/src/Packages_details.rst | 2 + doc/src/compute.rst | 2 + doc/src/compute_sna_atom.rst | 300 +++++++++++++++++++- doc/utils/sphinx-config/false_positives.txt | 3 + src/ML-SNAP/compute_sna_grid.h | 6 - src/ML-SNAP/compute_sna_grid_local.h | 8 - 8 files changed, 311 insertions(+), 18 deletions(-) diff --git a/doc/src/Commands_compute.rst b/doc/src/Commands_compute.rst index 61c5e83eda..bb0c3e9c2a 100644 --- a/doc/src/Commands_compute.rst +++ b/doc/src/Commands_compute.rst @@ -138,6 +138,8 @@ KOKKOS, o = OPENMP, t = OPT. * :doc:`smd/vol ` * :doc:`snap ` * :doc:`sna/atom ` + * :doc:`sna/grid ` + * :doc:`sna/grid/local ` * :doc:`snad/atom ` * :doc:`snav/atom ` * :doc:`sph/e/atom ` diff --git a/doc/src/Errors_warnings.rst b/doc/src/Errors_warnings.rst index 2d588a1b77..ab06ac523c 100644 --- a/doc/src/Errors_warnings.rst +++ b/doc/src/Errors_warnings.rst @@ -470,6 +470,12 @@ This will most likely cause errors in kinetic fluctuations. *More than one compute sna/atom* Self-explanatory. +*More than one compute sna/grid* + Self-explanatory. + +*More than one compute sna/grid/local* + Self-explanatory. + *More than one compute snad/atom* Self-explanatory. diff --git a/doc/src/Packages_details.rst b/doc/src/Packages_details.rst index aaac06a4a8..92a4cab46b 100644 --- a/doc/src/Packages_details.rst +++ b/doc/src/Packages_details.rst @@ -1801,6 +1801,8 @@ computes which analyze attributes of the potential. * src/ML-SNAP: filenames -> commands * :doc:`pair_style snap ` * :doc:`compute sna/atom ` +* :doc:`compute sna/grid ` +* :doc:`compute sna/grid/local ` * :doc:`compute snad/atom ` * :doc:`compute snav/atom ` * examples/snap diff --git a/doc/src/compute.rst b/doc/src/compute.rst index 6fdedbbb95..cf17433035 100644 --- a/doc/src/compute.rst +++ b/doc/src/compute.rst @@ -284,6 +284,8 @@ The individual style names on the :doc:`Commands compute ` pag * :doc:`smd/vol ` - per-particle volumes and their sum in Smooth Mach Dynamics * :doc:`snap ` - gradients of SNAP energy and forces w.r.t. linear coefficients and related quantities for fitting SNAP potentials * :doc:`sna/atom ` - bispectrum components for each atom +* :doc:`sna/grid ` - global array of bispectrum components on a regular grid +* :doc:`sna/grid/local ` - local array of bispectrum components on a regular grid * :doc:`snad/atom ` - derivative of bispectrum components for each atom * :doc:`snav/atom ` - virial contribution from bispectrum components for each atom * :doc:`sph/e/atom ` - per-atom internal energy of Smooth-Particle Hydrodynamics atoms diff --git a/doc/src/compute_sna_atom.rst b/doc/src/compute_sna_atom.rst index 54a6df02a2..2bbee1e6b6 100644 --- a/doc/src/compute_sna_atom.rst +++ b/doc/src/compute_sna_atom.rst @@ -24,6 +24,9 @@ Syntax compute ID group-ID snad/atom rcutfac rfac0 twojmax R_1 R_2 ... w_1 w_2 ... keyword values ... compute ID group-ID snav/atom rcutfac rfac0 twojmax R_1 R_2 ... w_1 w_2 ... keyword values ... compute ID group-ID snap rcutfac rfac0 twojmax R_1 R_2 ... w_1 w_2 ... keyword values ... + compute ID group-ID snap rcutfac rfac0 twojmax R_1 R_2 ... w_1 w_2 ... keyword values ... + compute ID group-ID sna/grid nx ny nz rcutfac rfac0 twojmax R_1 R_2 ... w_1 w_2 ... keyword values ... + compute ID group-ID sna/grid/local nx ny nz rcutfac rfac0 twojmax R_1 R_2 ... w_1 w_2 ... keyword values ... * ID, group-ID are documented in :doc:`compute ` command * sna/atom = style name of this compute command @@ -32,6 +35,7 @@ Syntax * twojmax = band limit for bispectrum components (non-negative integer) * R_1, R_2,... = list of cutoff radii, one for each type (distance units) * w_1, w_2,... = list of neighbor weights, one for each type +* nx, ny, nz = number of grid points in x, y, and z directions (positive integer) * zero or more keyword/value pairs may be appended * keyword = *rmin0* or *switchflag* or *bzeroflag* or *quadraticflag* or *chem* or *bnormflag* or *wselfallflag* or *bikflag* or *switchinnerflag* or *sinner* or *dinner* @@ -78,6 +82,7 @@ Examples compute snap all snap 1.4 0.95 6 2.0 1.0 compute snap all snap 1.0 0.99363 6 3.81 3.83 1.0 0.93 chem 2 0 1 compute snap all snap 1.0 0.99363 6 3.81 3.83 1.0 0.93 switchinnerflag 1 sinner 1.35 1.6 dinner 0.25 0.3 + compute bgrid all sna/grid/local 200 200 200 1.4 0.95 6 2.0 1.0 Description """"""""""" @@ -212,6 +217,46 @@ command: See section below on output for a detailed explanation of the data layout in the global array. +The compute *sna/grid* and *sna/grid/local* commands calculate +bispectrum components for a regular grid of points. +These are calculated from the local density of nearby atoms *i'* +around each grid point, as if there was a central atom *i* +at the grid point. This is useful for characterizing fine-scale +structure in a configuration of atoms, and it has been used +to build a machine-learning surrogate for finite-temperature Kohn-Sham +density functional theory (:ref:`Ellis et al. `). +Neighbor atoms not in the group do not contribute to the +bispectrum components of the grid points. The distance cutoff :math:`R_{ii'}` +and other parameters are defined as for a central atom with the same type as the +neighbor atoms *i'*. + +Compute *sna/grid* calculates a global array containing bispectrum +components for a regular grid of points. +The grid is aligned with the current box dimensions, with the +first point at the box origin, and forming a regular 3d array with +*nx*, *ny*, and *nz* points in the x, y, and z directions. For triclinic +boxes, the array is congruent with the periodic lattice vectors +a, b, and c. The array contains one row for each of the +:math:`nx \times ny \times nz` grid points, looping over the index for *ix* fastest, +then *iy*, and *iz* slowest. Each row of the array contains the *x*, *y*, +and *z* coordinates of the grid point, followed by the bispectrum +components. See section below on output for a detailed explanation of the data +layout in the global array. + +Compute *sna/grid/local* calculates bispectrum components of a regular +grid of points similarly to compute *sna/grid* described above. +However, because the array is local, it contains only rows for grid points +that are local to the processor subdomain. The global grid +of :math:`nx \times ny \times nz` points is still laid out in space the same as for *sna/grid*, +but grid points are strictly partitioned, so that every grid point appears in +one and only one local array. The array contains one row for each of the +local grid points, looping over the global index *ix* fastest, +then *iy*, and *iz* slowest. Each row of the array contains +the global indexes *ix*, *iy*, and *iz* first, followed by the *x*, *y*, +and *z* coordinates of the grid point, followed by the bispectrum +components. See section below on output for a detailed explanation of the data +layout in the global array. + The value of all bispectrum components will be zero for atoms not in the group. Neighbor atoms not in the group do not contribute to the bispectrum of atoms in the group. @@ -441,6 +486,250 @@ page for an overview of LAMMPS output options. To see how this command can be used within a Python workflow to train SNAP potentials, see the examples in `FitSNAP `_. +The value of all bispectrum components will be zero for atoms not in +the group. Neighbor atoms not in the group do not contribute to the +bispectrum of atoms in the group. + +The neighbor list needed to compute this quantity is constructed each +time the calculation is performed (i.e. each time a snapshot of atoms +is dumped). Thus it can be inefficient to compute/dump this quantity +too frequently. + +The argument *rcutfac* is a scale factor that controls the ratio of +atomic radius to radial cutoff distance. + +The argument *rfac0* and the optional keyword *rmin0* define the +linear mapping from radial distance to polar angle :math:`theta_0` on the +3-sphere, given above. + +The argument *twojmax* defines which +bispectrum components are generated. See section below on output for a +detailed explanation of the number of bispectrum components and the +ordered in which they are listed. + +The keyword *switchflag* can be used to turn off the switching +function :math:`f_c(r)`. + +The keyword *bzeroflag* determines whether or not *B0*, the bispectrum +components of an atom with no neighbors, are subtracted from the +calculated bispectrum components. This optional keyword normally only +affects compute *sna/atom*\ . However, when *quadraticflag* is on, it +also affects *snad/atom* and *snav/atom*\ . + +The keyword *quadraticflag* determines whether or not the quadratic +combinations of bispectrum quantities are generated. These are formed +by taking the outer product of the vector of bispectrum components with +itself. See section below on output for a detailed explanation of the +number of quadratic terms and the ordered in which they are listed. + +The keyword *chem* activates the explicit multi-element variant of the +SNAP bispectrum components. The argument *nelements* specifies the +number of SNAP elements that will be handled. This is followed by +*elementlist*, a list of integers of length *ntypes*, with values in the +range [0, *nelements* ), which maps each LAMMPS type to one of the SNAP +elements. Note that multiple LAMMPS types can be mapped to the same +element, and some elements may be mapped by no LAMMPS type. However, in +typical use cases (training SNAP potentials) the mapping from LAMMPS +types to elements is one-to-one. + +The explicit multi-element variant invoked by the *chem* keyword +partitions the density of neighbors into partial densities for each +chemical element. This is described in detail in the paper by +:ref:`Cusentino et al. ` The bispectrum components are +indexed on ordered triplets of elements: + +.. math:: + + B_{j_1,j_2,j}^{\kappa\lambda\mu} = + \sum_{m_1,m'_1=-j_1}^{j_1}\sum_{m_2,m'_2=-j_2}^{j_2}\sum_{m,m'=-j}^{j} (u^{\mu}_{j,m,m'})^* + H {\scriptscriptstyle \begin{array}{l} {j} {m} {m'} \\ + {j_1} {m_1} {m'_1} \\ + {j_2} {m_2} {m'_2} \end{array}} + u^{\kappa}_{j_1,m_1,m'_1} u^{\lambda}_{j_2,m_2,m'_2} + +where :math:`u^{\mu}_{j,m,m'}` is an expansion coefficient for the partial density of neighbors +of element :math:`\mu` + +.. math:: + + u^{\mu}_{j,m,m'} = w^{self}_{\mu_{i}\mu} U^{j,m,m'}(0,0,0) + \sum_{r_{ii'} < R_{ii'}}{\delta_{\mu\mu_{i'}}f_c(r_{ii'}) w_{\mu_{i'}} U^{j,m,m'}(\theta_0,\theta,\phi)} + +where :math:`w^{self}_{\mu_{i}\mu}` is the self-contribution, which is +either 1 or 0 (see keyword *wselfallflag* below), +:math:`\delta_{\mu\mu_{i'}}` indicates that the sum is only over +neighbor atoms of element :math:`\mu`, and all other quantities are the +same as those appearing in the original equation for :math:`u^j_{m,m'}` +given above. + +The keyword *wselfallflag* defines the rule used for the +self-contribution. If *wselfallflag* is on, then +:math:`w^{self}_{\mu_{i}\mu}` = 1. If it is off then +:math:`w^{self}_{\mu_{i}\mu}` = 0, except in the case of +:math:`{\mu_{i}=\mu}`, when :math:`w^{self}_{\mu_{i}\mu}` = 1. When the +*chem* keyword is not used, this keyword has no effect. + +The keyword *bnormflag* determines whether or not the bispectrum +component :math:`B_{j_1,j_2,j}` is divided by a factor of :math:`2j+1`. +This normalization simplifies force calculations because of the +following symmetry relation + +.. math:: + + \frac{B_{j_1,j_2,j}}{2j+1} = \frac{B_{j,j_2,j_1}}{2j_1+1} = \frac{B_{j_1,j,j_2}}{2j_2+1} + +This option is typically used in conjunction with the *chem* keyword, +and LAMMPS will generate a warning if both *chem* and *bnormflag* +are not both set or not both unset. + +The keyword *bikflag* determines whether or not to expand the bispectrum +rows of the global array returned by compute snap. If *bikflag* is set +to *1* then the bispectrum row, which is typically the per-atom bispectrum +descriptors :math:`B_{i,k}` summed over all atoms *i* to produce +:math:`B_k`, becomes bispectrum rows equal to the number of atoms. Thus, +the resulting bispectrum rows are :math:`B_{i,k}` instead of just +:math:`B_k`. In this case, the entries in the final column for these rows +are set to zero. + +The keyword *switchinnerflag* with value 1 +activates an additional radial switching +function similar to :math:`f_c(r)` above, but acting to switch off +smoothly contributions from neighbor atoms at short separation distances. +This is useful when SNAP is used in combination with a simple +repulsive potential. For a neighbor atom at +distance :math:`r`, its contribution is scaled by a multiplicative +factor :math:`f_{inner}(r)` defined as follows: + +.. math:: + + = & 0, r \leq S_{inner} - D_{inner} \\ + f_{inner}(r) = & \frac{1}{2}(1 - \cos(\frac{\pi}{2} (1 + \frac{r-S_{inner}}{D_{inner}})), S_{inner} - D_{inner} < r \leq S_{inner} + D_{inner} \\ + = & 1, r > S_{inner} + D_{inner} + +where the switching region is centered at :math:`S_{inner}` and it extends a distance :math:`D_{inner}` +to the left and to the right of this. +With this option, additional keywords *sinner* and *dinner* must be used, +each followed by *ntypes* +values for :math:`S_{inner}` and :math:`D_{inner}`, respectively. +When the central atom and the neighbor atom have different types, +the values of :math:`S_{inner}` and :math:`D_{inner}` are +the arithmetic means of the values for both types. + +.. note:: + + If you have a bonded system, then the settings of :doc:`special_bonds + ` command can remove pairwise interactions between + atoms in the same bond, angle, or dihedral. This is the default + setting for the :doc:`special_bonds ` command, and + means those pairwise interactions do not appear in the neighbor list. + Because this fix uses the neighbor list, it also means those pairs + will not be included in the calculation. One way to get around this, + is to write a dump file, and use the :doc:`rerun ` command to + compute the bispectrum components for snapshots in the dump file. + The rerun script can use a :doc:`special_bonds ` + command that includes all pairs in the neighbor list. + +---------- + +Output info +""""""""""" + +Compute *sna/atom* calculates a per-atom array, each column +corresponding to a particular bispectrum component. The total number of +columns and the identity of the bispectrum component contained in each +column depend of the value of *twojmax*, as described by the following +piece of python code: + +.. parsed-literal:: + + for j1 in range(0,twojmax+1): + for j2 in range(0,j1+1): + for j in range(j1-j2,min(twojmax,j1+j2)+1,2): + if (j>=j1): print j1/2.,j2/2.,j/2. + +For even twojmax = 2(*m*\ -1), :math:`K = m(m+1)(2m+1)/6`, the *m*\ -th pyramidal number. For odd twojmax = 2 *m*\ -1, :math:`K = m(m+1)(m+2)/3`, twice the *m*\ -th tetrahedral number. + +.. note:: + + the *diagonal* keyword allowing other possible choices + for the number of bispectrum components was removed in 2019, + since all potentials use the value of 3, corresponding to the + above set of bispectrum components. + +Compute *snad/atom* evaluates a per-atom array. The columns are arranged +into *ntypes* blocks, listed in order of atom type *I*\ . Each block +contains three sub-blocks corresponding to the *x*, *y*, and *z* +components of the atom position. Each of these sub-blocks contains *K* +columns for the *K* bispectrum components, the same as for compute +*sna/atom* + +Compute *snav/atom* evaluates a per-atom array. The columns are arranged +into *ntypes* blocks, listed in order of atom type *I*\ . Each block +contains six sub-blocks corresponding to the *xx*, *yy*, *zz*, +*yz*, *xz*, and *xy* components of the virial tensor in Voigt +notation. Each of these sub-blocks contains *K* columns for the *K* +bispectrum components, the same as for compute *sna/atom* + +Compute *snap* evaluates a global array. The columns are arranged into +*ntypes* blocks, listed in order of atom type *I*\ . Each block contains +one column for each bispectrum component, the same as for compute +*sna/atom*\ . A final column contains the corresponding energy, force +component on an atom, or virial stress component. The rows of the array +appear in the following order: + +* 1 row: *sna/atom* quantities summed for all atoms of type *I* +* 3\*\ *N* rows: *snad/atom* quantities, with derivatives w.r.t. x, y, and z coordinate of atom *i* appearing in consecutive rows. The atoms are sorted based on atom ID. +* 6 rows: *snav/atom* quantities summed for all atoms of type *I* + +For example, if *K* =30 and ntypes=1, the number of columns in the +per-atom arrays generated by *sna/atom*, *snad/atom*, and +*snav/atom* are 30, 90, and 180, respectively. With *quadratic* value=1, +the numbers of columns are 930, 2790, and 5580, respectively. The +number of columns in the global array generated by *snap* are 31, and +931, respectively, while the number of rows is 1+3\*\ *N*\ +6, where *N* +is the total number of atoms. + +If the *quadratic* keyword value is set to 1, then additional columns +are generated, corresponding to the products of all distinct pairs of +bispectrum components. If the number of bispectrum components is *K*, +then the number of distinct pairs is *K*\ (\ *K*\ +1)/2. For compute +*sna/atom* these columns are appended to existing *K* columns. The +ordering of quadratic terms is upper-triangular, (1,1),(1,2)...(1,\ *K*\ +),(2,1)...(\ *K*\ -1,\ *K*\ -1),(\ *K*\ -1,\ *K*\ ),(\ *K*,\ *K*\ ). +For computes *snad/atom* and *snav/atom* each set of *K*\ (\ *K*\ +1)/2 +additional columns is inserted directly after each of sub-block of +linear terms i.e. linear and quadratic terms are contiguous. So the +nesting order from inside to outside is bispectrum component, linear +then quadratic, vector/tensor component, type. + +If the *chem* keyword is used, then the data is arranged into +:math:`N_{elem}^3` sub-blocks, each sub-block corresponding to a +particular chemical labeling :math:`\kappa\lambda\mu` with the last +label changing fastest. Each sub-block contains *K* bispectrum +components. For the purposes of handling contributions to force, virial, +and quadratic combinations, these :math:`N_{elem}^3` sub-blocks are +treated as a single block of :math:`K N_{elem}^3` columns. + +These values can be accessed by any command that uses per-atom values +from a compute as input. See the :doc:`Howto output ` doc +page for an overview of LAMMPS output options. To see how this command +can be used within a Python workflow to train SNAP potentials, see the +examples in `FitSNAP `_. + +Compute *sna/grid* evaluates a global array. +The array contains one row for each of the +:math:`nx \times ny \times nz` grid points, looping over the index for *ix* fastest, +then *iy*, and *iz* slowest. Each row of the array contains the *x*, *y*, +and *z* coordinates of the grid point, followed by the bispectrum +components. + +Compute *sna/grid/local* evaluates a local array. +The array contains one row for each of the +local grid points, looping over the global index *ix* fastest, +then *iy*, and *iz* slowest. Each row of the array contains +the global indexes *ix*, *iy*, and *iz* first, followed by the *x*, *y*, +and *z* coordinates of the grid point, followed by the bispectrum +components. + Restrictions """""""""""" @@ -464,9 +753,8 @@ The optional keyword defaults are *rmin0* = 0, .. _Thompson20141: -**(Thompson)** Thompson, Swiler, Trott, Foiles, Tucker, under review, preprint -available at `arXiv:1409.3880 `_ - +**(Thompson)** Thompson, Swiler, Trott, Foiles, Tucker, J Comp Phys, 285, 316, (2015). + .. _Bartok20101: **(Bartok)** Bartok, Payne, Risi, Csanyi, Phys Rev Lett, 104, 136403 (2010). @@ -486,4 +774,8 @@ of Angular Momentum, World Scientific, Singapore (1987). .. _Cusentino2020: -**(Cusentino)** Cusentino, Wood, and Thompson, J Phys Chem A, xxx, xxxxx, (2020) +**(Cusentino)** Cusentino, Wood, Thompson, J Phys Chem A, 124, 5456, (2020) + +.. _Ellis2021: + +**(Ellis)** Ellis, Fiedler, Popoola, Modine, Stephens, Thompson, Cangi, Rajamanickam, Phys Rev B, 104, 035120, (2021) diff --git a/doc/utils/sphinx-config/false_positives.txt b/doc/utils/sphinx-config/false_positives.txt index 836dc4efa8..21f4549441 100644 --- a/doc/utils/sphinx-config/false_positives.txt +++ b/doc/utils/sphinx-config/false_positives.txt @@ -372,6 +372,7 @@ Caltech Camilloni Camiloni Campana +Cangi Cao Capolungo Caro @@ -2676,6 +2677,7 @@ polyhedra Polym polymorphism popen +Popoola Popov popstore Poresag @@ -2819,6 +2821,7 @@ radians Rafferty rahman Rahman +Rajamanickam Ralf Raman ramped diff --git a/src/ML-SNAP/compute_sna_grid.h b/src/ML-SNAP/compute_sna_grid.h index 777b874505..c203ce8bb4 100644 --- a/src/ML-SNAP/compute_sna_grid.h +++ b/src/ML-SNAP/compute_sna_grid.h @@ -63,12 +63,6 @@ Self-explanatory. Check the input script syntax and compare to the documentation for the command. You can use -echo screen as a command-line option when running LAMMPS to see the offending line. -E: Compute sna/grid requires a pair style be defined - -Self-explanatory. - -E: Compute sna/grid cutoff is longer than pairwise cutoff - Self-explanatory. W: More than one compute sna/grid diff --git a/src/ML-SNAP/compute_sna_grid_local.h b/src/ML-SNAP/compute_sna_grid_local.h index 853d629d87..5ce40069ee 100644 --- a/src/ML-SNAP/compute_sna_grid_local.h +++ b/src/ML-SNAP/compute_sna_grid_local.h @@ -63,14 +63,6 @@ Self-explanatory. Check the input script syntax and compare to the documentation for the command. You can use -echo screen as a command-line option when running LAMMPS to see the offending line. -E: Compute sna/grid/local requires a pair style be defined - -Self-explanatory. - -E: Compute sna/grid/local cutoff is longer than pairwise cutoff - -Self-explanatory. - W: More than one compute sna/grid/local Self-explanatory. From 21b3020a9734861ae6fd9782116b9c74b90840be Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 17 Jun 2022 00:10:06 -0400 Subject: [PATCH 381/585] make the "makewheel.py" script independent from the activate_this.py script The "activate_this.py" script only seems to be included in virtualenv, but not venv. Now we implement its effect directly. --- python/makewheel.py | 22 +++++++++++++++++----- 1 file changed, 17 insertions(+), 5 deletions(-) diff --git a/python/makewheel.py b/python/makewheel.py index a5b683aa63..f13ad110ce 100644 --- a/python/makewheel.py +++ b/python/makewheel.py @@ -1,14 +1,26 @@ #!/usr/bin/env python -import sys,os +import sys,os,site -# find python script to activate the virtual environment and source it +base = os.path.abspath('buildwheel') if sys.platform == 'win32': - virtenv=os.path.join('buildwheel','Scripts','activate_this.py') + bin_dir=os.path.join(base,'Scripts') else: - virtenv=os.path.join('buildwheel','bin','activate_this.py') + bin_dir=os.path.join(base,'bin') -exec(open(virtenv).read(), {'__file__': virtenv}) +# prepend bin to PATH, set venv path +os.environ["PATH"] = os.pathsep.join([bin_dir] + os.environ.get("PATH", "").split(os.pathsep)) +os.environ["VIRTUAL_ENV"] = base + +# add the virtual environments libraries to the host python import mechanism +prev_length = len(sys.path) +for lib in "__LIB_FOLDERS__".split(os.pathsep): + path = os.path.realpath(os.path.join(bin_dir, lib)) + site.addsitedir(path) +sys.path[:] = sys.path[prev_length:] + sys.path[0:prev_length] + +sys.real_prefix = sys.prefix +sys.prefix = base # update pip and install all requirements to build the wheel os.system('python -m pip install --upgrade pip') From 18f9e5836bd3e2e4fd9c91b9cc035d35cbac5232 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 17 Jun 2022 06:52:25 -0400 Subject: [PATCH 382/585] support installing the built wheel into virtual environment, if active --- python/install.py | 16 +++++++++++++--- 1 file changed, 13 insertions(+), 3 deletions(-) diff --git a/python/install.py b/python/install.py index e3a4dc9251..3c4be00779 100644 --- a/python/install.py +++ b/python/install.py @@ -84,6 +84,10 @@ if args.noinstall: # install the wheel with pip. first try to install in the default environment. # that will be a virtual environment, if active, or the system folder. +# if in a virtual environment, we must not use the python executable +# that is running this script (configured by cmake), but use "python" +# from the regular system path. The user may have changed to the virtual +# environment *after* running cmake. # recent versions of pip will automatically drop to use the user folder # in case the system folder is not writable. @@ -93,10 +97,16 @@ if args.noinstall: # must be uninstalled manually. We must not ignore this and drop # back to install into a (forced) user folder. -print("Installing wheel") +if "VIRTUAL_ENV" in os.environ: + print("Installing wheel into virtual environment") + py_exe = 'python' +else: + print("Installing wheel into system site-packages folder") + py_exe = sys.executable + for wheel in glob.glob('lammps-*.whl'): try: - txt = subprocess.check_output([sys.executable, '-m', 'pip', 'install', '--force-reinstall', wheel], stderr=subprocess.STDOUT, shell=False) + txt = subprocess.check_output([py_exe, '-m', 'pip', 'install', '--force-reinstall', wheel], stderr=subprocess.STDOUT, shell=False) print(txt.decode('UTF-8')) continue except subprocess.CalledProcessError as err: @@ -104,7 +114,7 @@ for wheel in glob.glob('lammps-*.whl'): if errmsg.find("distutils installed"): sys.exit(errmsg + "You need to uninstall the LAMMPS python module manually first.\n") try: - print('Installing wheel into standard site-packages folder failed. Trying user folder now') + print('Installing wheel into system site-packages folder failed. Trying user folder now') txt = subprocess.check_output([sys.executable, '-m', 'pip', 'install', '--user', '--force-reinstall', wheel], stderr=subprocess.STDOUT, shell=False) print(txt.decode('UTF-8')) except: From deac9f05b18624455da6c6782072cea01c9cb546 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 17 Jun 2022 08:05:28 -0400 Subject: [PATCH 383/585] move the created wheel to the build folder at the end --- cmake/CMakeLists.txt | 8 +++++--- python/install.py | 32 +++++++++++++++++++++++++++----- src/Makefile | 2 +- 3 files changed, 33 insertions(+), 9 deletions(-) diff --git a/cmake/CMakeLists.txt b/cmake/CMakeLists.txt index 6af33cd5b3..b0b8bfd363 100644 --- a/cmake/CMakeLists.txt +++ b/cmake/CMakeLists.txt @@ -786,14 +786,16 @@ if(BUILD_SHARED_LIBS) find_package(Python COMPONENTS Interpreter) endif() if(BUILD_IS_MULTI_CONFIG) - set(LIBLAMMPS_SHARED_BINARY ${CMAKE_BINARY_DIR}/$/liblammps${LAMMPS_MACHINE}${CMAKE_SHARED_LIBRARY_SUFFIX}) + set(MY_BUILD_DIR ${CMAKE_BINARY_DIR}/$) else() - set(LIBLAMMPS_SHARED_BINARY ${CMAKE_BINARY_DIR}/liblammps${LAMMPS_MACHINE}${CMAKE_SHARED_LIBRARY_SUFFIX}) + set(MY_BUILD_DIR ${CMAKE_BINARY_DIR}) endif() + set(LIBLAMMPS_SHARED_BINARY ${MY_BUILD_DIR}/liblammps${LAMMPS_MACHINE}${CMAKE_SHARED_LIBRARY_SUFFIX}) if(Python_EXECUTABLE) add_custom_target( install-python ${CMAKE_COMMAND} -E remove_directory build - COMMAND ${Python_EXECUTABLE} ${LAMMPS_PYTHON_DIR}/install.py -p ${LAMMPS_PYTHON_DIR}/lammps -l ${LIBLAMMPS_SHARED_BINARY} + COMMAND ${Python_EXECUTABLE} ${LAMMPS_PYTHON_DIR}/install.py -p ${LAMMPS_PYTHON_DIR}/lammps + -l ${LIBLAMMPS_SHARED_BINARY} -w ${MY_BUILD_DIR} COMMENT "Installing LAMMPS Python module") else() add_custom_target( diff --git a/python/install.py b/python/install.py index 3c4be00779..591e8525dc 100644 --- a/python/install.py +++ b/python/install.py @@ -23,6 +23,8 @@ parser.add_argument("-l", "--lib", required=True, help="path to the compiled LAMMPS shared library") parser.add_argument("-n", "--noinstall", action="store_true", default=False, help="only build a binary wheel. Don't attempt to install it") +parser.add_argument("-w", "--wheeldir", required=False, + help="path to a directory where the created wheel will be stored") args = parser.parse_args() @@ -30,7 +32,7 @@ args = parser.parse_args() if args.package: if not os.path.exists(args.package): - print( "ERROR: LAMMPS package %s does not exist" % args.package) + print("ERROR: LAMMPS package %s does not exist" % args.package) parser.print_help() sys.exit(1) else: @@ -38,12 +40,20 @@ if args.package: if args.lib: if not os.path.exists(args.lib): - print( "ERROR: LAMMPS shared library %s does not exist" % args.lib) + print("ERROR: LAMMPS shared library %s does not exist" % args.lib) parser.print_help() sys.exit(1) else: args.lib = os.path.abspath(args.lib) +if args.wheeldir: + if not os.path.exists(args.wheeldir): + print("ERROR: directory %s to store the wheel does not exist" % args.wheeldir) + parser.print_help() + sys.exit(1) + else: + args.wheeldir = os.path.abspath(args.wheeldir) + # we need to switch to the folder of the python package olddir = os.path.abspath('.') os.chdir(os.path.dirname(args.package)) @@ -80,7 +90,11 @@ os.remove(os.path.join('lammps',os.path.basename(args.lib))) # stop here if we were asked not to install the wheel we created if args.noinstall: - exit(0) + if args.wheeldir: + for wheel in glob.glob('lammps-*.whl'): + shutil.copy(wheel, args.wheeldir) + os.remove(wheel) + exit(0) # install the wheel with pip. first try to install in the default environment. # that will be a virtual environment, if active, or the system folder. @@ -108,6 +122,11 @@ for wheel in glob.glob('lammps-*.whl'): try: txt = subprocess.check_output([py_exe, '-m', 'pip', 'install', '--force-reinstall', wheel], stderr=subprocess.STDOUT, shell=False) print(txt.decode('UTF-8')) + if args.wheeldir: + shutil.copy(wheel, args.wheeldir) + else: + shutil.copy(wheel, olddir) + os.remove(wheel) continue except subprocess.CalledProcessError as err: errmsg = err.output.decode('UTF-8') @@ -117,7 +136,10 @@ for wheel in glob.glob('lammps-*.whl'): print('Installing wheel into system site-packages folder failed. Trying user folder now') txt = subprocess.check_output([sys.executable, '-m', 'pip', 'install', '--user', '--force-reinstall', wheel], stderr=subprocess.STDOUT, shell=False) print(txt.decode('UTF-8')) + if args.wheeldir: + shutil.copy(wheel, args.wheeldir) + else: + shutil.copy(wheel, olddir) + os.remove(wheel) except: sys.exit('Failed to install wheel ' + wheel) - shutil.copy(wheel, olddir) - os.remove(wheel) diff --git a/src/Makefile b/src/Makefile index ab8e5c4fea..649a1ad002 100644 --- a/src/Makefile +++ b/src/Makefile @@ -461,7 +461,7 @@ mpi-stubs: sinclude ../lib/python/Makefile.lammps install-python: @rm -rf ../python/build - @$(PYTHON) ../python/install.py -p ../python/lammps -l ../src/liblammps.so + @$(PYTHON) ../python/install.py -p ../python/lammps -l ../src/liblammps.so -w $(PWD) # Create a tarball of src dir and packages From e201d6e77e9ce45250a1caf5e4a44301cb3ab2a0 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Thu, 16 Jun 2022 20:31:06 -0600 Subject: [PATCH 384/585] Delete files --- examples/snap/README.grid | 19 -- examples/snap/econs.py | 16 - examples/snap/fnum.py | 14 - examples/snap/grid.local.py | 121 -------- examples/snap/grid.py | 104 ------- examples/snap/in.fnum | 61 ---- examples/snap/in.grid | 83 ------ examples/snap/in.grid.local | 77 ----- examples/snap/in.grid.pair | 90 ------ examples/snap/in.grid.python | 65 ----- examples/snap/in.grid.python.local | 69 ----- examples/snap/in.grid.test | 105 ------- examples/snap/lammps_utils.py | 26 -- src/ML-SNAP/pair_sna_grid.cpp | 449 ----------------------------- src/ML-SNAP/pair_sna_grid.h | 79 ----- src/pair_grid.cpp | 328 --------------------- src/pair_grid.h | 87 ------ 17 files changed, 1793 deletions(-) delete mode 100644 examples/snap/README.grid delete mode 100644 examples/snap/econs.py delete mode 100644 examples/snap/fnum.py delete mode 100755 examples/snap/grid.local.py delete mode 100755 examples/snap/grid.py delete mode 100644 examples/snap/in.fnum delete mode 100644 examples/snap/in.grid delete mode 100644 examples/snap/in.grid.local delete mode 100644 examples/snap/in.grid.pair delete mode 100644 examples/snap/in.grid.python delete mode 100644 examples/snap/in.grid.python.local delete mode 100644 examples/snap/in.grid.test delete mode 100644 examples/snap/lammps_utils.py delete mode 100644 src/ML-SNAP/pair_sna_grid.cpp delete mode 100644 src/ML-SNAP/pair_sna_grid.h delete mode 100644 src/pair_grid.cpp delete mode 100644 src/pair_grid.h diff --git a/examples/snap/README.grid b/examples/snap/README.grid deleted file mode 100644 index a552ce38ab..0000000000 --- a/examples/snap/README.grid +++ /dev/null @@ -1,19 +0,0 @@ -This branch contains the following examples: - -in.grid # simple example of grid -in.grid.local # simple example of grid/local -in.grid.python # used by grid.py -in.grid.test # stress test of grid and grid/local -in.grid.tri # grid with triclinic cell - -grid.py # access data from Python library interface - -For the LAMMPS public repo, the only examples that will be provided are: - - in.grid.snap # simple test of grid and grid/local - in.grid.tri # same for a triclinic box - log.15Jun22.grid.snap.g++.1 - log.15Jun22.grid.snap.g++.4 - log.15Jun22.grid.tri.g++.1 - log.15Jun22.grid.tri.g++.4 - diff --git a/examples/snap/econs.py b/examples/snap/econs.py deleted file mode 100644 index aece097622..0000000000 --- a/examples/snap/econs.py +++ /dev/null @@ -1,16 +0,0 @@ -import lammps - -infile = "in.grid.pair" -faclist = [0.001,0.002, 0.005, 0.01, 0.02, 0.05, 0.1, 0.2, 0.5] - -print("# Timestep DeltaE DeltaE/Timestep^2") -for fac in faclist: - cmdlist = ["-screen","none","-var","dtfac", "%g" % fac] - lmp = lammps.lammps(cmdargs = cmdlist) - lmp.file(infile) - dt = lmp.extract_global("dt", lammps.LAMMPS_DOUBLE) - de = lmp.extract_fix("avede", lammps.LMP_STYLE_GLOBAL, lammps.LMP_TYPE_SCALAR) - dedt2 = de/dt**2 - print(f"{dt} {de} {dedt2}") - - diff --git a/examples/snap/fnum.py b/examples/snap/fnum.py deleted file mode 100644 index 1e50e49b09..0000000000 --- a/examples/snap/fnum.py +++ /dev/null @@ -1,14 +0,0 @@ -import lammps - -infile = "in.fnum" - -fdeltalist = [1.0e-2,1.0e-3,1.0e-4,1.0e-5,1.0e-6,1.0e-7,1.0e-8,1.0e-9,1.0e-10] - -print("Fdelta RMSE") -for fdelta in fdeltalist: - cmdlist = ["-screen","none","-var","fdelta",f'{fdelta}'] - lmp = lammps.lammps(cmdargs = cmdlist) - lmp.file(infile) - faverrsq = lmp.extract_compute("faverrsq", lammps.LMP_STYLE_GLOBAL, lammps.LMP_TYPE_SCALAR) - rmse = faverrsq**0.5 - print(f"{fdelta} {rmse}") diff --git a/examples/snap/grid.local.py b/examples/snap/grid.local.py deleted file mode 100755 index 414558b79b..0000000000 --- a/examples/snap/grid.local.py +++ /dev/null @@ -1,121 +0,0 @@ -#!/Users/athomps/miniconda3/bin/python3.7 -# -# An example of SNAP grid from LAMMPS Python interface -# -# https://lammps.sandia.gov/doc/Python_library.html - - -from lammps import lammps, LMP_STYLE_LOCAL, LMP_SIZE_ROWS, LMP_SIZE_COLS, LMP_TYPE_ARRAY -import lammps_utils - -from mpi4py import MPI -comm = MPI.COMM_WORLD -me = comm.Get_rank() -nprocs = comm.Get_size() - -# define command line input variables - -ngridx = 2 -ngridy = 3 -ngridz = nprocs -twojmax = 2 - -lmp_cmdargs = ["-echo","screen"] -lmp_cmdargs = lammps_utils.set_cmdlinevars(lmp_cmdargs, - { - "ngridx":ngridx, - "ngridy":ngridy, - "ngridz":ngridz, - "twojmax":twojmax - } - ) - -# launch LAMMPS instance - -lmp = lammps(cmdargs=lmp_cmdargs) - -# run LAMMPS input script - -lmp.file("in.grid.python.local") - -# get quantities from LAMMPS - -num_atoms = lmp.get_natoms() - -# set things not accessible from LAMMPS - -# first 3 cols are x, y, z, coords - -ncols0 = 3 - -# analytical relation - -ncoeff = (twojmax+2)*(twojmax+3)*(twojmax+4) -ncoeff = ncoeff // 24 # integer division -ncols = ncols0+ncoeff - -# get B_0 at position (0,0,0) in 4 different ways - -# 1. from comute sna/atom - -bptr = lmp.extract_compute("b", 1, 2) # 1 = per-atom data, 2 = array -print("b = ",bptr[0][0]) - -# 2. from compute sna/grid - -bgridptr = lmp.extract_compute("bgrid", 0, 2) # 0 = style global, 2 = type array -print("bgrid = ",bgridptr[0][3]) - -# 3. from Numpy array pointing to sna/atom array - -bptr_np = lammps_utils.extract_compute_np(lmp,"b",1,2,(num_atoms,ncoeff)) -print("b_np = ",bptr_np[0][0]) - -# 4. from Numpy array pointing to sna/grid array - -bgridptr_np = lammps_utils.extract_compute_np(lmp,"bgrid",0,2,(ngridz,ngridy,ngridx,ncols)) -print("bgrid_np = ",bgridptr_np[0][0][0][ncols0+0]) - -# 5. from sna/grid/local array - -bgridlocalnrows = lmp.extract_compute("bgridlocal", LMP_STYLE_LOCAL, LMP_SIZE_ROWS) -print("bgridlocal nrows = ",bgridlocalnrows) -bgridlocalncols = lmp.extract_compute("bgridlocal", LMP_STYLE_LOCAL, LMP_SIZE_COLS) -print("bgridlocal ncols = ",bgridlocalncols) - -if bgridlocalnrows > 0: - bgridlocalptr = lmp.extract_compute("bgridlocal", LMP_STYLE_LOCAL, LMP_TYPE_ARRAY) - print("bgridlocal = ",bgridlocalptr) - print("bgridlocal[0][0] = ",bgridlocalptr[5][10]) - -# print out the LAMMPS array to a file - -outfile = open("bgrid.dat",'w') -igrid = 0 -for iz in range(ngridz): - for iy in range(ngridy): - for ix in range(ngridx): - outfile.write("x, y, z = %g %g %g\n" % - (bgridptr[igrid][0], - bgridptr[igrid][1], - bgridptr[igrid][2])) - for icoeff in range(ncoeff): - outfile.write("%g " % bgridptr[igrid][ncols0+icoeff]) - outfile.write("\n") - igrid += 1 -outfile.close() - -# print out the Numpy array to a file - -outfile = open("bgrid_np.dat",'w') -for iz in range(ngridz): - for iy in range(ngridy): - for ix in range(ngridx): - outfile.write("x, y, z = %g %g %g\n" % - (bgridptr_np[iz][iy][ix][0], - bgridptr_np[iz][iy][ix][1], - bgridptr_np[iz][iy][ix][2])) - for icoeff in range(ncoeff): - outfile.write("%g " % bgridptr_np[iz][iy][ix][ncols0+icoeff]) - outfile.write("\n") -outfile.close() diff --git a/examples/snap/grid.py b/examples/snap/grid.py deleted file mode 100755 index 9fe88fd1b4..0000000000 --- a/examples/snap/grid.py +++ /dev/null @@ -1,104 +0,0 @@ -#!/Users/athomps/miniconda3/bin/python3.7 -# -# An example of SNAP grid from LAMMPS Python interface -# -# https://lammps.sandia.gov/doc/Python_library.html - - -from lammps import lammps -import lammps_utils - -# define command line input variables - -ngridx = 2 -ngridy = 3 -ngridz = 4 -twojmax = 2 - -lmp_cmdargs = ["-echo","screen"] -lmp_cmdargs = lammps_utils.set_cmdlinevars(lmp_cmdargs, - { - "ngridx":ngridx, - "ngridy":ngridy, - "ngridz":ngridz, - "twojmax":twojmax - } - ) - -# launch LAMMPS instance - -lmp = lammps(cmdargs=lmp_cmdargs) - -# run LAMMPS input script - -lmp.file("in.grid.python") - -# get quantities from LAMMPS - -num_atoms = lmp.get_natoms() - -# set things not accessible from LAMMPS - -# first 3 cols are x, y, z, coords - -ncols0 = 3 - -# analytical relation - -ncoeff = (twojmax+2)*(twojmax+3)*(twojmax+4) -ncoeff = ncoeff // 24 # integer division -ncols = ncols0+ncoeff - -# get B_0 at position (0,0,0) in 4 different ways - -# 1. from comute sna/atom - -bptr = lmp.extract_compute("b", 1, 2) # 1 = per-atom data, 2 = array -print("b = ",bptr[0][0]) - -# 2. from compute sna/grid - -bgridptr = lmp.extract_compute("bgrid", 0, 2) # 0 = style global, 2 = type array -print("bgrid = ",bgridptr[0][3]) - -# 3. from Numpy array pointing to sna/atom array - -bptr_np = lammps_utils.extract_compute_np(lmp,"b",1,2,(num_atoms,ncoeff)) -print("b_np = ",bptr_np[0][0]) - -# 4. from Numpy array pointing to sna/grid array - -bgridptr_np = lammps_utils.extract_compute_np(lmp,"bgrid",0,2,(ngridz,ngridy,ngridx,ncols)) -print("bgrid_np = ",bgridptr_np[0][0][0][ncols0+0]) - -# print out the LAMMPS array to a file - -outfile = open("bgrid.dat",'w') -igrid = 0 -for iz in range(ngridz): - for iy in range(ngridy): - for ix in range(ngridx): - outfile.write("x, y, z = %g %g %g\n" % - (bgridptr[igrid][0], - bgridptr[igrid][1], - bgridptr[igrid][2])) - for icoeff in range(ncoeff): - outfile.write("%g " % bgridptr[igrid][ncols0+icoeff]) - outfile.write("\n") - igrid += 1 -outfile.close() - -# print out the Numpy array to a file - -outfile = open("bgrid_np.dat",'w') -for iz in range(ngridz): - for iy in range(ngridy): - for ix in range(ngridx): - outfile.write("x, y, z = %g %g %g\n" % - (bgridptr_np[iz][iy][ix][0], - bgridptr_np[iz][iy][ix][1], - bgridptr_np[iz][iy][ix][2])) - for icoeff in range(ncoeff): - outfile.write("%g " % bgridptr_np[iz][iy][ix][ncols0+icoeff]) - outfile.write("\n") -outfile.close() diff --git a/examples/snap/in.fnum b/examples/snap/in.fnum deleted file mode 100644 index 1298e9aed9..0000000000 --- a/examples/snap/in.fnum +++ /dev/null @@ -1,61 +0,0 @@ -# Demonstrate pair style base on sna/grid -# Check numerical forces - -variable nrep index 3 -variable a index 3.0 -variable ngrid index 2 -variable del index 0.1 -variable fdelta index 0.0001 - -units metal - -atom_modify map yes - -# generate the box and atom positions using a BCC lattice - -variable nx equal ${nrep} -variable ny equal ${nrep} -variable nz equal ${nrep} - -boundary p p p - -lattice custom $a & - a1 1 0 0 & - a2 0 1 0 & - a3 0 0 1 & - basis 0 0 0 & - basis 0.5 0.5 0.5 & -# origin 0.25 0.25 0.25 -# origin 0.25e-3 0.25e-3 0.25e-3 - -region box block 0 ${nx} 0 ${ny} 0 ${nz} -create_box 1 box -create_atoms 1 box -mass 1 180.88 -displace_atoms all random ${del} ${del} ${del} 12345 - -# define grid compute and atom compute - -group snapgroup type 1 -variable twojmax equal 2 -variable rcutfac equal 4.67637 -variable rfac0 equal 0.99363 -variable rmin0 equal 0 -variable wj equal 1 -variable radelem equal 0.5 -variable bzero equal 0 -variable quad equal 0 -variable switch equal 1 - -pair_style sna/grid grid ${ngrid} ${ngrid} ${ngrid} & - ${rcutfac} ${rfac0} ${twojmax} ${radelem} & - ${wj} rmin0 ${rmin0} bzeroflag ${bzero} & - quadraticflag ${quad} switchflag ${switch} -pair_coeff * * Al - -fix fnum all numdiff 1 ${fdelta} -variable ferrsq atom (fx-f_fnum[1])^2+(fy-f_fnum[2])^2+(fz-f_fnum[3])^2 -compute faverrsq all reduce ave v_ferrsq -thermo_style custom c_faverrsq - -run 0 diff --git a/examples/snap/in.grid b/examples/snap/in.grid deleted file mode 100644 index 44c42673e0..0000000000 --- a/examples/snap/in.grid +++ /dev/null @@ -1,83 +0,0 @@ -# Demonstrate bispectrum computes - -# CORRECTNESS: thermo output for c_mygrid[*][1] and c_mygrid[*][8] should -# match the values in dump_b: 108.173 3.21778 0.712238 7.06634 1.04273 - -# Initialize simulation - -variable nsteps index 0 -variable nrep index 1 -variable a index 3.316 -variable ngrid index 2 - -units metal - -# generate the box and atom positions using a BCC lattice - -variable nx equal ${nrep} -variable ny equal ${nrep} -variable nz equal ${nrep} - -boundary p p p - -lattice custom $a & - a1 1 0 0 & - a2 0 1 0 & - a3 0 0 1 & - basis 0 0 0 & - basis 0.5 0.5 0.5 & -# origin 0.25 0.25 0.25 - -region box block 0 ${nx} 0 ${ny} 0 ${nz} -create_box 1 box -create_atoms 1 box - -mass 1 180.88 - -# choose potential - -include Ta06A.snap - -# define grid compute and atom compute - -group snapgroup type 1 -variable twojmax equal 2 -variable rcutfac equal 4.67637 -variable rfac0 equal 0.99363 -variable rmin0 equal 0 -variable wj equal 1 -variable radelem equal 0.5 -variable bzero equal 0 -variable quad equal 0 -variable switch equal 1 - -compute b all sna/atom & - ${rcutfac} ${rfac0} ${twojmax} ${radelem} & - ${wj} rmin0 ${rmin0} bzeroflag ${bzero} & - quadraticflag ${quad} switchflag ${switch} - -compute mygrid all sna/grid grid ${ngrid} ${ngrid} ${ngrid} & - ${rcutfac} ${rfac0} ${twojmax} ${radelem} & - ${wj} rmin0 ${rmin0} bzeroflag ${bzero} & - quadraticflag ${quad} switchflag ${switch} - -# define output - -# mygrid is ngrid by (3+nbis) = 8x8 -thermo_style custom step temp ke pe vol & - c_mygrid[1][1] c_mygrid[2][1] c_mygrid[3][1] c_mygrid[4][1] c_mygrid[5][1] c_mygrid[6][1] c_mygrid[7][1] c_mygrid[8][1] & - c_mygrid[1][2] c_mygrid[2][2] c_mygrid[3][2] c_mygrid[4][2] c_mygrid[5][2] c_mygrid[6][2] c_mygrid[7][2] c_mygrid[8][2] & - c_mygrid[1][3] c_mygrid[2][3] c_mygrid[3][3] c_mygrid[4][3] c_mygrid[5][3] c_mygrid[6][3] c_mygrid[7][3] c_mygrid[8][3] & - c_mygrid[1][4] c_mygrid[2][4] c_mygrid[3][4] c_mygrid[4][4] c_mygrid[5][4] c_mygrid[6][4] c_mygrid[7][4] c_mygrid[8][4] & - c_mygrid[1][5] c_mygrid[2][5] c_mygrid[3][5] c_mygrid[4][5] c_mygrid[5][5] c_mygrid[6][5] c_mygrid[7][5] c_mygrid[8][5] & - c_mygrid[1][6] c_mygrid[2][6] c_mygrid[3][6] c_mygrid[4][6] c_mygrid[5][6] c_mygrid[6][6] c_mygrid[7][6] c_mygrid[8][6] & - c_mygrid[1][7] c_mygrid[2][7] c_mygrid[3][7] c_mygrid[4][7] c_mygrid[5][7] c_mygrid[6][7] c_mygrid[7][7] c_mygrid[8][7] & - c_mygrid[1][8] c_mygrid[2][8] c_mygrid[3][8] c_mygrid[4][8] c_mygrid[5][8] c_mygrid[6][8] c_mygrid[7][8] c_mygrid[8][8] -thermo_modify norm yes - -dump mydump_b all custom 1000 dump_b id c_b[*] - -# run - -run 0 - diff --git a/examples/snap/in.grid.local b/examples/snap/in.grid.local deleted file mode 100644 index 121f0ba981..0000000000 --- a/examples/snap/in.grid.local +++ /dev/null @@ -1,77 +0,0 @@ -# Demonstrate bispectrum computes with local grid - -# Initialize simulation - -variable nsteps index 0 -variable nrep index 1 -variable a index 3.316 -variable ngrid index 2 - -units metal - -# generate the box and atom positions using a BCC lattice - -variable nx equal ${nrep} -variable ny equal ${nrep} -variable nz equal ${nrep} - -boundary p p p - -lattice custom $a & - a1 1 0 0 & - a2 0 1 0 & - a3 0 0 1 & - basis 0 0 0 & - basis 0.5 0.5 0.5 & -# origin 0.25 0.25 0.25 - -region box block 0 ${nx} 0 ${ny} 0 ${nz} -create_box 1 box -create_atoms 1 box - -mass 1 180.88 - -# choose potential - -include Ta06A.snap - -# define grid compute and atom compute - -group snapgroup type 1 -variable twojmax equal 2 -variable rcutfac equal 4.67637 -variable rfac0 equal 0.99363 -variable rmin0 equal 0 -variable wj equal 1 -variable radelem equal 0.5 -variable bzero equal 0 -variable quad equal 0 -variable switch equal 1 - -compute b all sna/atom & - ${rcutfac} ${rfac0} ${twojmax} ${radelem} & - ${wj} rmin0 ${rmin0} bzeroflag ${bzero} & - quadraticflag ${quad} switchflag ${switch} - -compute mygridlocal all sna/grid/local grid ${ngrid} ${ngrid} ${ngrid} & - ${rcutfac} ${rfac0} ${twojmax} ${radelem} & - ${wj} rmin0 ${rmin0} bzeroflag ${bzero} & - quadraticflag ${quad} switchflag ${switch} - -# define output - -# mygrid is ngrid by (3+nbis) = 8x8 -thermo_style custom step temp ke pe vol -thermo_modify norm yes - -dump mydump_b all custom 1000 dump_b id c_b[*] -dump mydump_bgridlocal all local 1000 dump_bgridlocal index c_mygridlocal[*] - -# run - -run 0 - -run 0 - -run 0 - diff --git a/examples/snap/in.grid.pair b/examples/snap/in.grid.pair deleted file mode 100644 index 128da2ad7a..0000000000 --- a/examples/snap/in.grid.pair +++ /dev/null @@ -1,90 +0,0 @@ -# Demonstrate pair style base on sna/grid -# Test energy conservation -# Choose dtfac in the range [0.01,Infinity] -# Large dtfac means small timestep, while -# keeping trajectory output interval fixed -# Variable etotdelta measures change in (PE+KE)/natoms - -# Initialize simulation - -variable dtfac index 1 -variable dt equal 0.5e-3/${dtfac} -variable nthermo equal 1000*${dtfac} -variable nsteps equal 1000*${dtfac} -variable nrep index 3 -variable a index 3.0 -variable ngrid index 2 -variable t index 300 -variable del index 0.1 - -units metal - -atom_modify map yes - -# generate the box and atom positions using a BCC lattice - -variable nx equal ${nrep} -variable ny equal ${nrep} -variable nz equal ${nrep} - -boundary p p p - -lattice custom $a & - a1 1 0 0 & - a2 0 1 0 & - a3 0 0 1 & - basis 0 0 0 & - basis 0.5 0.5 0.5 & -# origin 0.25 0.25 0.25 -# origin 0.25e-3 0.25e-3 0.25e-3 - -region box block 0 ${nx} 0 ${ny} 0 ${nz} -create_box 1 box -create_atoms 1 box -mass 1 180.88 -displace_atoms all random ${del} ${del} ${del} 12345 -velocity all create $t 4928459 loop geom - -write_dump all custom test.dump id type x y z - -# define grid compute and atom compute - -group snapgroup type 1 -variable twojmax equal 2 -variable rcutfac equal 4.67637 -variable rfac0 equal 0.99363 -variable rmin0 equal 0 -variable wj equal 1 -variable radelem equal 0.5 -variable bzero equal 0 -variable quad equal 0 -variable switch equal 1 - -pair_style sna/grid grid ${ngrid} ${ngrid} ${ngrid} & - ${rcutfac} ${rfac0} ${twojmax} ${radelem} & - ${wj} rmin0 ${rmin0} bzeroflag ${bzero} & - quadraticflag ${quad} switchflag ${switch} -pair_coeff * * Al - -thermo ${nthermo} -thermo_modify norm yes - -run 0 -variable etot0 equal etotal -variable etotdelta equal abs(etotal-${etot0})/atoms -fix avede all ave/time 1 ${nthermo} ${nthermo} v_etotdelta - -thermo_style custom step temp epair ke etotal press v_etotdelta f_avede -thermo ${nthermo} -thermo_modify norm yes - -# Set up NVE run - -timestep ${dt} -neighbor 1.0 bin -neigh_modify once no every 1 delay 0 check yes - -# Run MD - -fix mynve all nve -run ${nsteps} diff --git a/examples/snap/in.grid.python b/examples/snap/in.grid.python deleted file mode 100644 index e04415d558..0000000000 --- a/examples/snap/in.grid.python +++ /dev/null @@ -1,65 +0,0 @@ -# Demonstrate bispectrum per-atom and grid computes - -# Invoked from grid.py -# pass in values for ngridx, ngridy, ngridz, twojmax - -# Initialize simulation - -variable nsteps equal 0 -variable nrep equal 1 -variable a equal 3.316 - -units metal - -# generate the box and atom positions using a BCC lattice - -variable nx equal ${nrep} -variable ny equal ${nrep} -variable nz equal ${nrep} - -boundary p p p - -lattice custom ${a} a1 1 0 0 a2 0 1 0 a3 0 0 1 basis 0 0 0 basis 0.5 0.5 0.5 - -region box block 0 ${nx} 0 ${ny} 0 ${nz} -create_box 1 box -create_atoms 1 box - -mass 1 180.88 - -# define grid compute and atom compute - -group snapgroup type 1 -variable rcutfac equal 4.67637 -variable rfac0 equal 0.99363 -variable rmin0 equal 0 -variable wj equal 1 -variable radelem equal 0.5 -variable bzero equal 0 -variable quad equal 0 -variable switch equal 1 - -compute b all sna/atom ${rcutfac} ${rfac0} ${twojmax} ${radelem} ${wj} rmin0 ${rmin0} bzeroflag ${bzero} quadraticflag ${quad} switchflag ${switch} - -compute bgrid all sna/grid grid ${ngridx} ${ngridy} ${ngridz} ${rcutfac} ${rfac0} ${twojmax} ${radelem} ${wj} rmin0 ${rmin0} bzeroflag ${bzero} quadraticflag ${quad} switchflag ${switch} - -compute bgridlocal all sna/grid/local grid ${ngridx} ${ngridy} ${ngridz} ${rcutfac} ${rfac0} ${twojmax} ${radelem} ${wj} rmin0 ${rmin0} bzeroflag ${bzero} quadraticflag ${quad} switchflag ${switch} - -# create dummy potential for neighbor list - -variable rcutneigh equal 2.0*${rcutfac}*${radelem} -pair_style zero ${rcutneigh} -pair_coeff * * - -# define output - -thermo_style custom step temp ke pe vol c_bgrid[1][1] -thermo_modify norm yes - -dump mydump_b all custom 1000 dump_b id c_b[*] - -dump mydump_bgridlocal all local 1000 dump_bgridlocal index c_bgridlocal[1] - -# run - -run 0 diff --git a/examples/snap/in.grid.python.local b/examples/snap/in.grid.python.local deleted file mode 100644 index af95696a2b..0000000000 --- a/examples/snap/in.grid.python.local +++ /dev/null @@ -1,69 +0,0 @@ -# Demonstrate bispectrum per-atom and grid computes - -# Invoked from grid.py -# pass in values for ngridx, ngridy, ngridz, twojmax - -# Initialize simulation - -variable nsteps equal 0 -variable nrep equal 1 -variable a equal 3.316 - -units metal - -# make processor grid equal to nz - -processors 1 1 ${ngridz} - -# generate the box and atom positions using a BCC lattice - -variable nx equal ${nrep} -variable ny equal ${nrep} -variable nz equal ${nrep} - -boundary p p p - -lattice custom ${a} a1 1 0 0 a2 0 1 0 a3 0 0 1 basis 0 0 0 basis 0.5 0.5 0.5 - -region box block 0 ${nx} 0 ${ny} 0 ${nz} -create_box 1 box -create_atoms 1 box - -mass 1 180.88 - -# define grid compute and atom compute - -group snapgroup type 1 -variable rcutfac equal 4.67637 -variable rfac0 equal 0.99363 -variable rmin0 equal 0 -variable wj equal 1 -variable radelem equal 0.5 -variable bzero equal 0 -variable quad equal 0 -variable switch equal 1 - -compute b all sna/atom ${rcutfac} ${rfac0} ${twojmax} ${radelem} ${wj} rmin0 ${rmin0} bzeroflag ${bzero} quadraticflag ${quad} switchflag ${switch} - -compute bgrid all sna/grid grid ${ngridx} ${ngridy} ${ngridz} ${rcutfac} ${rfac0} ${twojmax} ${radelem} ${wj} rmin0 ${rmin0} bzeroflag ${bzero} quadraticflag ${quad} switchflag ${switch} - -compute bgridlocal all sna/grid/local grid ${ngridx} ${ngridy} ${ngridz} ${rcutfac} ${rfac0} ${twojmax} ${radelem} ${wj} rmin0 ${rmin0} bzeroflag ${bzero} quadraticflag ${quad} switchflag ${switch} - -# create dummy potential for neighbor list - -variable rcutneigh equal 2.0*${rcutfac}*${radelem} -pair_style zero ${rcutneigh} -pair_coeff * * - -# define output - -thermo_style custom step temp ke pe vol c_bgrid[1][1] -thermo_modify norm yes - -dump mydump_b all custom 1000 dump_b id c_b[*] - -dump mydump_bgridlocal all local 1000 dump_bgridlocal index c_bgridlocal[*] - -# run - -run 0 diff --git a/examples/snap/in.grid.test b/examples/snap/in.grid.test deleted file mode 100644 index c684200d44..0000000000 --- a/examples/snap/in.grid.test +++ /dev/null @@ -1,105 +0,0 @@ -# Demonstrate bispectrum computes - -# CORRECTNESS: thermo output for c_mygrid[*][1] and c_mygrid[*][8] should -# match the values in dump_b: 108.173 3.21778 0.712238 7.06634 1.04273 - -# Initialize simulation - -variable nsteps index 0 -variable nrep index 3 -variable a index 3.316 -variable ngrid index 2 - -units metal - -atom_modify map yes - -# generate the box and atom positions using a BCC lattice - -variable nx equal ${nrep} -variable ny equal ${nrep} -variable nz equal ${nrep} - -boundary p p p - -lattice custom $a & - a1 1 0 0 & - a2 0 1 0 & - a3 0 0 1 & - basis 0 0 0 & - basis 0.5 0.5 0.5 & -# origin 0.25 0.25 0.25 -# origin 0.25e-3 0.25e-3 0.25e-3 - -region box block 0 ${nx} 0 ${ny} 0 ${nz} -create_box 1 box -create_atoms 1 box - -mass 1 180.88 - -write_dump all custom test.dump id type x y z - -# choose potential - -include Ta06A.snap - -# define grid compute and atom compute - -group snapgroup type 1 -variable twojmax equal 2 -variable rcutfac equal 4.67637 -variable rfac0 equal 0.99363 -variable rmin0 equal 0 -variable wj equal 1 -variable radelem equal 0.5 -variable bzero equal 0 -variable quad equal 0 -variable switch equal 1 - -compute b all sna/atom & - ${rcutfac} ${rfac0} ${twojmax} ${radelem} & - ${wj} rmin0 ${rmin0} bzeroflag ${bzero} & - quadraticflag ${quad} switchflag ${switch} - -compute mygrid all sna/grid grid ${ngrid} ${ngrid} ${ngrid} & - ${rcutfac} ${rfac0} ${twojmax} ${radelem} & - ${wj} rmin0 ${rmin0} bzeroflag ${bzero} & - quadraticflag ${quad} switchflag ${switch} - -compute mygridlocal all sna/grid/local grid ${ngrid} ${ngrid} ${ngrid} & - ${rcutfac} ${rfac0} ${twojmax} ${radelem} & - ${wj} rmin0 ${rmin0} bzeroflag ${bzero} & - quadraticflag ${quad} switchflag ${switch} - -# define output - -# mygrid is ngrid by (3+nbis) = 8x8 -thermo_style custom step temp ke pe vol & - c_mygrid[1][1] c_mygrid[2][1] c_mygrid[3][1] c_mygrid[4][1] c_mygrid[5][1] c_mygrid[6][1] c_mygrid[7][1] c_mygrid[8][1] & - c_mygrid[1][2] c_mygrid[2][2] c_mygrid[3][2] c_mygrid[4][2] c_mygrid[5][2] c_mygrid[6][2] c_mygrid[7][2] c_mygrid[8][2] & - c_mygrid[1][3] c_mygrid[2][3] c_mygrid[3][3] c_mygrid[4][3] c_mygrid[5][3] c_mygrid[6][3] c_mygrid[7][3] c_mygrid[8][3] & - c_mygrid[1][4] c_mygrid[2][4] c_mygrid[3][4] c_mygrid[4][4] c_mygrid[5][4] c_mygrid[6][4] c_mygrid[7][4] c_mygrid[8][4] & - c_mygrid[1][5] c_mygrid[2][5] c_mygrid[3][5] c_mygrid[4][5] c_mygrid[5][5] c_mygrid[6][5] c_mygrid[7][5] c_mygrid[8][5] & - c_mygrid[1][6] c_mygrid[2][6] c_mygrid[3][6] c_mygrid[4][6] c_mygrid[5][6] c_mygrid[6][6] c_mygrid[7][6] c_mygrid[8][6] & - c_mygrid[1][7] c_mygrid[2][7] c_mygrid[3][7] c_mygrid[4][7] c_mygrid[5][7] c_mygrid[6][7] c_mygrid[7][7] c_mygrid[8][7] & - c_mygrid[1][8] c_mygrid[2][8] c_mygrid[3][8] c_mygrid[4][8] c_mygrid[5][8] c_mygrid[6][8] c_mygrid[7][8] c_mygrid[8][8] -thermo_modify norm yes - -#dump mydump_b all custom 1 dump_b id c_b[*] -dump mydump_bgridlocal all local 1 dump_bgridlocal index c_mygridlocal[*] - -# run - -run 1 - -# rcb - -comm_style tiled -balance 0.99 rcb -run 1 - -# rcb again - -balance 0.99 rcb -run 1 - diff --git a/examples/snap/lammps_utils.py b/examples/snap/lammps_utils.py deleted file mode 100644 index ea74459a74..0000000000 --- a/examples/snap/lammps_utils.py +++ /dev/null @@ -1,26 +0,0 @@ -import numpy as np -import ctypes - -def set_cmdlinevars(cmdargs, argdict): - for key in argdict.keys(): - cmdargs += ["-var",key,f"{argdict[key]}"] - return cmdargs - -def extract_commands(string): - return [x for x in string.splitlines() if x.strip() != ''] - -def extract_compute_np(lmp,name,compute_type,result_type,array_shape): - """ - Convert a lammps compute to a numpy array. - Assumes the compute returns a floating point numbers. - Note that the result is a view into the original memory. - If the result type is 0 (scalar) then conversion to numpy is skipped and a python float is returned. - """ - ptr = lmp.extract_compute(name, compute_type, result_type) # 1,2: Style (1) is per-atom compute, returns array type (2). - if result_type == 0: return ptr # No casting needed, lammps.py already works - if result_type == 2: ptr = ptr.contents - total_size = np.prod(array_shape) - buffer_ptr = ctypes.cast(ptr, ctypes.POINTER(ctypes.c_double * total_size)) - array_np = np.frombuffer(buffer_ptr.contents, dtype=float) - array_np.shape = array_shape - return array_np diff --git a/src/ML-SNAP/pair_sna_grid.cpp b/src/ML-SNAP/pair_sna_grid.cpp deleted file mode 100644 index ffb4dfa033..0000000000 --- a/src/ML-SNAP/pair_sna_grid.cpp +++ /dev/null @@ -1,449 +0,0 @@ -/* ---------------------------------------------------------------------- - LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator - http://lammps.sandia.gov, Sandia National Laboratories - Steve Plimpton, sjplimp@sandia.gov - - Copyright (2003) Sandia Corporation. Under the terms of Contract - DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains - certain rights in this software. This software is distributed under - the GNU General Public License. - - See the README file in the top-level LAMMPS directory. -------------------------------------------------------------------------- */ - -#include "pair_grid.h" -#include "pair_sna_grid.h" -#include "sna.h" -#include "atom.h" -#include "update.h" -#include "modify.h" -#include "neighbor.h" -#include "neigh_list.h" -#include "neigh_request.h" -#include "force.h" -#include "pair.h" -#include "domain.h" -#include "comm.h" -#include "memory.h" -#include "error.h" -#include "tokenizer.h" - -#include -#include - -using namespace LAMMPS_NS; - -PairSNAGrid::PairSNAGrid(LAMMPS *lmp) : - PairGrid(lmp), - radelem(nullptr), wjelem(nullptr) -{ - snaptr = nullptr; -} - -/* ---------------------------------------------------------------------- */ - -PairSNAGrid::~PairSNAGrid() -{ - memory->destroy(radelem); - memory->destroy(wjelem); - memory->destroy(cutsq); - delete snaptr; - - if (chemflag) memory->destroy(map); -} - -/* ---------------------------------------------------------------------- */ - -void PairSNAGrid::init_style() -{ - if (force->newton_pair == 0) - error->all(FLERR,"Pair style sna/grid requires newton pair on"); - - snaptr = new SNA(lmp, rfac0, twojmax, - rmin0, switchflag, bzeroflag, - chemflag, bnormflag, wselfallflag, - nelements, switchinnerflag); - ncoeff = snaptr->ncoeff; - ndesc = ndesc_base + ncoeff; - snaptr->init(); - -} - -/* ---------------------------------------------------------------------- */ - -void PairSNAGrid::init_list(int /*id*/, NeighList *ptr) -{ - list = ptr; -} - -/* ---------------------------------------------------------------------- */ - -void PairSNAGrid::compute(int eflag, int vflag) -{ - double fij[3]; - - ev_init(eflag,vflag); - - // compute sna for each gridpoint - - double** const x = atom->x; - double **f = atom->f; - const int* const mask = atom->mask; - int * const type = atom->type; - const int ntotal = atom->nlocal + atom->nghost; - - // insure rij, inside, and typej are of size ntotal - - snaptr->grow_rij(ntotal); - - // first generate fingerprint, - // which allows calculation of beta - - for (int iz = nzlo; iz <= nzhi; iz++) - for (int iy = nylo; iy <= nyhi; iy++) - for (int ix = nxlo; ix <= nxhi; ix++) { - double xgrid[3]; - grid2x(ix, iy, iz, xgrid); - const double xtmp = xgrid[0]; - const double ytmp = xgrid[1]; - const double ztmp = xgrid[2]; - - // currently, all grid points are type 1 - - const int itype = 1; - int ielem = 0; - if (chemflag) - ielem = map[itype]; - const double radi = radelem[itype]; - - // rij[][3] = displacements between atom I and those neighbors - // inside = indices of neighbors of I within cutoff - // typej = types of neighbors of I within cutoff - - int ninside = 0; - for (int j = 0; j < ntotal; j++) { - - const double delx = xtmp - x[j][0]; - const double dely = ytmp - x[j][1]; - const double delz = ztmp - x[j][2]; - const double rsq = delx*delx + dely*dely + delz*delz; - int jtype = type[j]; - int jelem = 0; - if (chemflag) - jelem = map[jtype]; - if (rsq < cutsq[jtype][jtype] && rsq > 1e-20) { - snaptr->rij[ninside][0] = delx; - snaptr->rij[ninside][1] = dely; - snaptr->rij[ninside][2] = delz; - snaptr->inside[ninside] = j; - snaptr->wj[ninside] = wjelem[jtype]; - snaptr->rcutij[ninside] = 2.0*radelem[jtype]*rcutfac; - snaptr->element[ninside] = jelem; // element index for multi-element snap - ninside++; - } - } - - snaptr->compute_ui(ninside, ielem); - snaptr->compute_zi(); - snaptr->compute_bi(ielem); - - // linear contributions - - for (int icoeff = 0; icoeff < ncoeff; icoeff++) - gridlocal[ndesc_base+icoeff][iz][iy][ix] = - snaptr->blist[icoeff]; - - // quadratic contributions - // untested - - if (quadraticflag) { - int ncount = ncoeff; - for (int icoeff = 0; icoeff < ncoeff; icoeff++) { - double bveci = snaptr->blist[icoeff]; - gridlocal[ndesc_base+ncount++][iz][iy][ix] = - 0.5*bveci*bveci; - for (int jcoeff = icoeff+1; jcoeff < ncoeff; jcoeff++) - gridlocal[ndesc_base+ncount++][iz][iy][ix] = - bveci*snaptr->blist[jcoeff]; - } - } - } - - // this is a proxy for a call to the energy model - // beta is dE/dB^i, the derivative of the total - // energy w.r.t. to descriptors of grid point i - - compute_beta(); - - // second compute forces using beta - - int igrid = 0; - for (int iz = nzlo; iz <= nzhi; iz++) - for (int iy = nylo; iy <= nyhi; iy++) - for (int ix = nxlo; ix <= nxhi; ix++) { - double xgrid[3]; - grid2x(ix, iy, iz, xgrid); - const double xtmp = xgrid[0]; - const double ytmp = xgrid[1]; - const double ztmp = xgrid[2]; - - // currently, all grid points are type 1 - - const int itype = 1; - int ielem = 0; - if (chemflag) - ielem = map[itype]; - const double radi = radelem[itype]; - - // rij[][3] = displacements between atom I and those neighbors - // inside = indices of neighbors of I within cutoff - // typej = types of neighbors of I within cutoff - - int ninside = 0; - for (int j = 0; j < ntotal; j++) { - - const double delx = xtmp - x[j][0]; - const double dely = ytmp - x[j][1]; - const double delz = ztmp - x[j][2]; - const double rsq = delx*delx + dely*dely + delz*delz; - int jtype = type[j]; - int jelem = 0; - jelem = map[jtype]; - - if (rsq < cutsq[jtype][jtype] && rsq > 1e-20) { - snaptr->rij[ninside][0] = delx; - snaptr->rij[ninside][1] = dely; - snaptr->rij[ninside][2] = delz; - snaptr->inside[ninside] = j; - snaptr->wj[ninside] = wjelem[jtype]; - snaptr->rcutij[ninside] = 2.0*radelem[jtype]*rcutfac; - if (switchinnerflag) { - snaptr->sinnerij[ninside] = 0.5*(sinnerelem[ielem]+sinnerelem[jelem]); - snaptr->dinnerij[ninside] = 0.5*(dinnerelem[ielem]+dinnerelem[jelem]); - } - if (chemflag) snaptr->element[ninside] = jelem; - ninside++; - } - } - - // compute Ui, Yi for atom I - - if (chemflag) - snaptr->compute_ui(ninside, ielem); - else - snaptr->compute_ui(ninside, 0); - - // for neighbors of I within cutoff: - // compute Fij = dEi/dRj = -dEi/dRi - // add to Fi, subtract from Fj - // scaling is that for type I - - snaptr->compute_yi(beta[igrid]); - - for (int jj = 0; jj < ninside; jj++) { - int j = snaptr->inside[jj]; - snaptr->compute_duidrj(jj); - - snaptr->compute_deidrj(fij); - - f[j][0] += fij[0]; - f[j][1] += fij[1]; - f[j][2] += fij[2]; - - // tally per-atom virial contribution - - if (vflag) - ev_tally_xyz(-1,j,atom->nlocal,force->newton_pair,0.0,0.0, - fij[0],fij[1],fij[2], - -snaptr->rij[jj][0],-snaptr->rij[jj][1], - -snaptr->rij[jj][2]); - } - - // tally energy contribution - - if (eflag) { - - // get descriptors again - - snaptr->compute_zi(); - snaptr->compute_bi(ielem); - - // evdwl = energy of atom I, sum over coeffs_k * Bi_k - - double evdwl = 0.0; - - // E = beta.B - - for (int icoeff = 0; icoeff < ncoeff; icoeff++) - evdwl += beta[igrid][icoeff]*snaptr->blist[icoeff]; - - ev_tally_full(-1,2.0*evdwl,0.0,0.0,0.0,0.0,0.0); - - } - igrid++; - } - - if (vflag_fdotr) virial_fdotr_compute(); - -} - - -/* ---------------------------------------------------------------------- - global settings -------------------------------------------------------------------------- */ - -void PairSNAGrid::settings(int narg, char ** arg) -{ - - // call base class first - - PairGrid::settings(narg, arg); - - // skip over arguments used by base class - // so that argument positions are identical to - // regular per-atom compute - - arg += nargbase; - narg -= nargbase; - - int ntypes = atom->ntypes; - int nargmin = 3+2*ntypes; - - if (narg < nargmin) error->all(FLERR,"Illegal pair sna/grid command"); - - // default values - - rmin0 = 0.0; - switchflag = 1; - bzeroflag = 1; - quadraticflag = 0; - chemflag = 0; - bnormflag = 0; - wselfallflag = 0; - switchinnerflag = 0; - nelements = 1; - - // process required arguments - - memory->create(radelem,ntypes+1,"pair:sna/grid:radelem"); // offset by 1 to match up with types - memory->create(wjelem,ntypes+1,"pair:sna/grid:wjelem"); - - rcutfac = atof(arg[0]); - rfac0 = atof(arg[1]); - twojmax = atoi(arg[2]); - - for(int i = 0; i < ntypes; i++) - radelem[i+1] = atof(arg[3+i]); - for(int i = 0; i < ntypes; i++) - wjelem[i+1] = atof(arg[3+ntypes+i]); - - // construct cutsq - - double cut; - cutmax = 0.0; - memory->create(cutsq,ntypes+1,ntypes+1,"pair:sna/grid:cutsq"); - for(int i = 1; i <= ntypes; i++) { - cut = 2.0*radelem[i]*rcutfac; - if (cut > cutmax) cutmax = cut; - cutsq[i][i] = cut*cut; - for(int j = i+1; j <= ntypes; j++) { - cut = (radelem[i]+radelem[j])*rcutfac; - cutsq[i][j] = cutsq[j][i] = cut*cut; - } - } - - // set local input checks - - int sinnerflag = 0; - int dinnerflag = 0; - - // process optional args - - int iarg = nargmin; - - while (iarg < narg) { - if (strcmp(arg[iarg],"rmin0") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal pair sna/grid command"); - rmin0 = atof(arg[iarg+1]); - iarg += 2; - } else if (strcmp(arg[iarg],"switchflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal pair sna/grid command"); - switchflag = atoi(arg[iarg+1]); - iarg += 2; - } else if (strcmp(arg[iarg],"bzeroflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal pair sna/grid command"); - bzeroflag = atoi(arg[iarg+1]); - iarg += 2; - } else if (strcmp(arg[iarg],"quadraticflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal pair sna/grid command"); - quadraticflag = atoi(arg[iarg+1]); - iarg += 2; - } else if (strcmp(arg[iarg],"chem") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal pair sna/grid command"); - chemflag = 1; - memory->create(map,ntypes+1,"pair:sna/grid:map"); - nelements = utils::inumeric(FLERR,arg[iarg+1],false,lmp); - for (int i = 0; i < ntypes; i++) { - int jelem = utils::inumeric(FLERR,arg[iarg+2+i],false,lmp); - if (jelem < 0 || jelem >= nelements) - error->all(FLERR,"Illegal pair sna/grid command"); - map[i+1] = jelem; - } - iarg += 2+ntypes; - } else if (strcmp(arg[iarg],"bnormflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal pair sna/grid command"); - bnormflag = atoi(arg[iarg+1]); - iarg += 2; - } else if (strcmp(arg[iarg],"wselfallflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal pair sna/grid command"); - wselfallflag = atoi(arg[iarg+1]); - iarg += 2; - } else if (strcmp(arg[iarg],"switchinnerflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal pair sna/grid command"); - switchinnerflag = atoi(arg[iarg+1]); - iarg += 2; - } else if (strcmp(arg[iarg],"sinner") == 0) { - iarg++; - if (iarg+ntypes > narg) - error->all(FLERR,"Illegal pair sna/grid command"); - memory->create(sinnerelem,ntypes+1,"snap:sinnerelem"); - for (int i = 0; i < ntypes; i++) - sinnerelem[i+1] = utils::numeric(FLERR,arg[iarg+i],false,lmp); - sinnerflag = 1; - iarg += ntypes; - } else if (strcmp(arg[iarg],"dinner") == 0) { - iarg++; - if (iarg+ntypes > narg) - error->all(FLERR,"Illegal pair sna/grid command"); - memory->create(dinnerelem,ntypes+1,"snap:dinnerelem"); - for (int i = 0; i < ntypes; i++) - dinnerelem[i+1] = utils::numeric(FLERR,arg[iarg+i],false,lmp); - dinnerflag = 1; - iarg += ntypes; - } else error->all(FLERR,"Illegal pair sna/grid command"); - - } - -} - -/* ---------------------------------------------------------------------- - memory usage -------------------------------------------------------------------------- */ - -double PairSNAGrid::memory_usage() -{ - double nbytes = snaptr->memory_usage(); // SNA object - int n = atom->ntypes+1; - nbytes += (double)n*sizeof(int); // map - - return nbytes; -} - diff --git a/src/ML-SNAP/pair_sna_grid.h b/src/ML-SNAP/pair_sna_grid.h deleted file mode 100644 index 653bb9d1c1..0000000000 --- a/src/ML-SNAP/pair_sna_grid.h +++ /dev/null @@ -1,79 +0,0 @@ -/* -*- c++ -*- ---------------------------------------------------------- - LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator - https://www.lammps.org/, Sandia National Laboratories - Steve Plimpton, sjplimp@sandia.gov - - Copyright (2003) Sandia Corporation. Under the terms of Contract - DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains - certain rights in this software. This software is distributed under - the GNU General Public License. - - See the README file in the top-level LAMMPS directory. -------------------------------------------------------------------------- */ - -#ifdef PAIR_CLASS -// clang-format off -PairStyle(sna/grid, PairSNAGrid); -// clang-format on -#else - -#ifndef LMP_PAIR_SNA_GRID_H -#define LMP_PAIR_SNA_GRID_H - -#include "pair_grid.h" - -namespace LAMMPS_NS { - -class PairSNAGrid : public PairGrid { - public: - PairSNAGrid(class LAMMPS *); - ~PairSNAGrid(); - - void init_style(); - void init_list(int, class NeighList *); - void settings(int, char **); - void compute(int, int); - double memory_usage(); - - private: - int ncoeff; - class NeighList *list; - double rcutfac; - double *radelem; - double *wjelem; - class SNA *snaptr; - int quadraticflag; - int twojmax, switchflag, bzeroflag, bnormflag; - int chemflag, wselfallflag; - int switchinnerflag; - double *sinnerelem; - double *dinnerelem; - double rfac0, rmin0; -}; - -} - -#endif -#endif - -/* ERROR/WARNING messages: - -E: Illegal ... command - -Self-explanatory. Check the input script syntax and compare to the -documentation for the command. You can use -echo screen as a -command-line option when running LAMMPS to see the offending line. - -E: Compute sna/grid/local requires a pair style be defined - -Self-explanatory. - -E: Compute sna/grid/local cutoff is longer than pairwise cutoff - -Self-explanatory. - -W: More than one compute sna/grid/local - -Self-explanatory. - -*/ diff --git a/src/pair_grid.cpp b/src/pair_grid.cpp deleted file mode 100644 index 1f17553055..0000000000 --- a/src/pair_grid.cpp +++ /dev/null @@ -1,328 +0,0 @@ -/* ---------------------------------------------------------------------- - LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator - http://lammps.sandia.gov, Sandia National Laboratories - Steve Plimpton, sjplimp@sandia.gov - - Copyright (2003) Sandia Corporation. Under the terms of Contract - DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains - certain rights in this software. This software is distributed under - the GNU General Public License. - - See the README file in the top-level LAMMPS directory. -------------------------------------------------------------------------- */ - -#include "pair_grid.h" -#include -#include -#include "atom.h" -#include "update.h" -#include "modify.h" -#include "domain.h" -#include "force.h" -#include "memory.h" -#include "error.h" -#include "comm.h" - -#define BETA_CONST 1.0e-2 - -using namespace LAMMPS_NS; - -/* ---------------------------------------------------------------------- */ - -PairGrid::PairGrid(LAMMPS *lmp) : - Pair(lmp), gridlocal(nullptr), alocal(nullptr), beta(nullptr) -{ - single_enable = 0; - restartinfo = 0; - one_coeff = 1; - manybody_flag = 1; - centroidstressflag = CENTROID_NOTAVAIL; - - ndesc = 0; - ngridlocal = 0; - - ndesc_base = 6; - gridlocal_allocated = 0; - beta_max = 0; - beta = nullptr; -} - -/* ---------------------------------------------------------------------- */ - -PairGrid::~PairGrid() -{ - if (copymode) return; - deallocate_grid(); -} - -/* ---------------------------------------------------------------------- */ - -void PairGrid::setup() -{ - deallocate_grid(); - set_grid_global(); - set_grid_local(); - allocate_grid(); - assign_coords(); -} - -/* ---------------------------------------------------------------------- - convert global array indexes to box coords -------------------------------------------------------------------------- */ - -void PairGrid::grid2x(int ix, int iy, int iz, double *x) -{ - x[0] = ix*delx; - x[1] = iy*dely; - x[2] = iz*delz; - - if (triclinic) domain->lamda2x(x, x); -} - -/* ---------------------------------------------------------------------- - create arrays -------------------------------------------------------------------------- */ - -void PairGrid::allocate_grid() -{ - if (nxlo <= nxhi && nylo <= nyhi && nzlo <= nzhi) { - gridlocal_allocated = 1; - memory->create4d_offset(gridlocal,ndesc,nzlo,nzhi,nylo,nyhi, - nxlo,nxhi,"pair/grid:gridlocal"); - memory->create(alocal, ngridlocal, ndesc, "pair/grid:alocal"); - memory->create(beta, ngridlocal, ndesc-ndesc_base, "pair/grid:beta"); - } -} - -/* ---------------------------------------------------------------------- - free arrays -------------------------------------------------------------------------- */ - -void PairGrid::deallocate_grid() -{ - if (gridlocal_allocated) { - gridlocal_allocated = 0; - memory->destroy4d_offset(gridlocal,nzlo,nylo,nxlo); - memory->destroy(alocal); - memory->destroy(beta); - } -} - -/* ---------------------------------------------------------------------- - set global grid -------------------------------------------------------------------------- */ - -void PairGrid::set_grid_global() -{ - // calculate grid layout - - triclinic = domain->triclinic; - - if (triclinic == 0) { - prd = domain->prd; - boxlo = domain->boxlo; - sublo = domain->sublo; - subhi = domain->subhi; - } else { - prd = domain->prd_lamda; - boxlo = domain->boxlo_lamda; - sublo = domain->sublo_lamda; - subhi = domain->subhi_lamda; - } - - double xprd = prd[0]; - double yprd = prd[1]; - double zprd = prd[2]; - - delxinv = nx/xprd; - delyinv = ny/yprd; - delzinv = nz/zprd; - - delx = 1.0/delxinv; - dely = 1.0/delyinv; - delz = 1.0/delzinv; -} - -/* ---------------------------------------------------------------------- - set local subset of grid that I own - n xyz lo/hi = 3d brick that I own (inclusive) -------------------------------------------------------------------------- */ - -void PairGrid::set_grid_local() -{ - // nx,ny,nz = extent of global grid - // indices into the global grid range from 0 to N-1 in each dim - // if grid point is inside my sub-domain I own it, - // this includes sub-domain lo boundary but excludes hi boundary - // ixyz lo/hi = inclusive lo/hi bounds of global grid sub-brick I own - // if proc owns no grid cells in a dim, then ilo > ihi - // if 2 procs share a boundary a grid point is exactly on, - // the 2 equality if tests insure a consistent decision - // as to which proc owns it - - double xfraclo,xfrachi,yfraclo,yfrachi,zfraclo,zfrachi; - - if (comm->layout != Comm::LAYOUT_TILED) { - xfraclo = comm->xsplit[comm->myloc[0]]; - xfrachi = comm->xsplit[comm->myloc[0]+1]; - yfraclo = comm->ysplit[comm->myloc[1]]; - yfrachi = comm->ysplit[comm->myloc[1]+1]; - zfraclo = comm->zsplit[comm->myloc[2]]; - zfrachi = comm->zsplit[comm->myloc[2]+1]; - } else { - xfraclo = comm->mysplit[0][0]; - xfrachi = comm->mysplit[0][1]; - yfraclo = comm->mysplit[1][0]; - yfrachi = comm->mysplit[1][1]; - zfraclo = comm->mysplit[2][0]; - zfrachi = comm->mysplit[2][1]; - } - - nxlo = static_cast (xfraclo * nx); - if (1.0*nxlo != xfraclo*nx) nxlo++; - nxhi = static_cast (xfrachi * nx); - if (1.0*nxhi == xfrachi*nx) nxhi--; - - nylo = static_cast (yfraclo * ny); - if (1.0*nylo != yfraclo*ny) nylo++; - nyhi = static_cast (yfrachi * ny); - if (1.0*nyhi == yfrachi*ny) nyhi--; - - nzlo = static_cast (zfraclo * nz); - if (1.0*nzlo != zfraclo*nz) nzlo++; - nzhi = static_cast (zfrachi * nz); - if (1.0*nzhi == zfrachi*nz) nzhi--; - - ngridlocal = (nxhi - nxlo + 1) * (nyhi - nylo + 1) * (nzhi - nzlo + 1); -} - -/* ---------------------------------------------------------------------- - copy coords to local array -------------------------------------------------------------------------- */ - -void PairGrid::assign_coords() -{ - int igrid = 0; - for (int iz = nzlo; iz <= nzhi; iz++) - for (int iy = nylo; iy <= nyhi; iy++) - for (int ix = nxlo; ix <= nxhi; ix++) { - alocal[igrid][0] = ix; - alocal[igrid][1] = iy; - alocal[igrid][2] = iz; - double xgrid[3]; - grid2x(ix, iy, iz, xgrid); - alocal[igrid][3] = xgrid[0]; - alocal[igrid][4] = xgrid[1]; - alocal[igrid][5] = xgrid[2]; - igrid++; - } -} - -/* ---------------------------------------------------------------------- - copy the 4d gridlocal array values to the 2d local array -------------------------------------------------------------------------- */ - -void PairGrid::copy_gridlocal_to_local_array() -{ - int igrid = 0; - for (int iz = nzlo; iz <= nzhi; iz++) - for (int iy = nylo; iy <= nyhi; iy++) - for (int ix = nxlo; ix <= nxhi; ix++) { - for (int icol = ndesc_base; icol < ndesc; icol++) - alocal[igrid][icol] = gridlocal[icol][iz][iy][ix]; - igrid++; - } -} - -/* ---------------------------------------------------------------------- - calculate beta -------------------------------------------------------------------------- */ - - // this is a proxy for a call to the energy model - // beta is dE/dB^i, the derivative of the total - // energy w.r.t. to descriptors of grid point i - -void PairGrid::compute_beta() -{ - int igrid = 0; - for (int iz = nzlo; iz <= nzhi; iz++) - for (int iy = nylo; iy <= nyhi; iy++) - for (int ix = nxlo; ix <= nxhi; ix++) { - for (int icol = 0; icol < ndesc-ndesc_base; icol++) - beta[igrid][icol] = BETA_CONST; - igrid++; - } -} - -/* ---------------------------------------------------------------------- - allocate all arrays -------------------------------------------------------------------------- */ - -void PairGrid::allocate() -{ - allocated = 1; - int n = atom->ntypes; - memory->create(setflag,n+1,n+1,"pair:setflag"); - for (int i = 1; i <= n; i++) - for (int j = i; j <= n; j++) - setflag[i][j] = 0; - - memory->create(cutsq,n+1,n+1,"pair:cutsq"); - map = new int[n+1]; -} - -/* ---------------------------------------------------------------------- - global settings -------------------------------------------------------------------------- */ - -void PairGrid::settings(int narg, char ** arg) -{ - if (narg < 4) error->all(FLERR,"Illegal pair style command"); - int iarg0 = 0; - int iarg = iarg0; - if (strcmp(arg[iarg],"grid") == 0) { - if (iarg+4 > narg) error->all(FLERR,"Illegal pair grid command"); - nx = utils::inumeric(FLERR,arg[iarg+1],false,lmp); - ny = utils::inumeric(FLERR,arg[iarg+2],false,lmp); - nz = utils::inumeric(FLERR,arg[iarg+3],false,lmp); - if (nx <= 0 || ny <= 0 || nz <= 0) - error->all(FLERR,"All grid/local dimensions must be positive"); - iarg += 4; - } else error->all(FLERR,"Illegal pair grid command"); - nargbase = iarg - iarg0; -} - -/* ---------------------------------------------------------------------- - set coeffs for one or more type pairs -------------------------------------------------------------------------- */ - -void PairGrid::coeff(int narg, char **arg) -{ - if (!allocated) allocate(); - if (narg < 2) error->all(FLERR,"Incorrect args for pair coefficients"); - // if (narg != 2 + atom->ntypes) error->all(FLERR,"Incorrect args for pair coefficients"); - - map_element2type(narg-2,arg+2); - // map_element2type(0,nullptr); - -} - -/* ---------------------------------------------------------------------- - return maximum force cut off distance -------------------------------------------------------------------------- */ - -double PairGrid::init_one(int i, int j) -{ - if (setflag[i][j] == 0) error->all(FLERR,"All pair coeffs are not set"); - return cutmax; -} - -/* ---------------------------------------------------------------------- - memory usage of local data -------------------------------------------------------------------------- */ - -double PairGrid::memory_usage() -{ - int nbytes = ndesc*ngridlocal*sizeof(double); // gridlocal - return nbytes; -} diff --git a/src/pair_grid.h b/src/pair_grid.h deleted file mode 100644 index b5bf7ad9ef..0000000000 --- a/src/pair_grid.h +++ /dev/null @@ -1,87 +0,0 @@ -/* -*- c++ -*- ---------------------------------------------------------- - LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator - http://lammps.sandia.gov, Sandia National Laboratories - Steve Plimpton, sjplimp@sandia.gov - - Copyright (2003) Sandia Corporation. Under the terms of Contract - DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains - certain rights in this software. This software is distributed under - the GNU General Public License. - - See the README file in the top-level LAMMPS directory. -------------------------------------------------------------------------- */ - -#ifdef PAIR_CLASS -// clang-format off -PairStyle(grid,PairGrid); -// clang-format on -#else - -#ifndef LMP_PAIR_GRID_H -#define LMP_PAIR_GRID_H - -#include "pair.h" - -namespace LAMMPS_NS { - -class PairGrid : public Pair { - public: - PairGrid(class LAMMPS *); - virtual ~PairGrid(); - virtual void init_style(){}; - void setup(); - virtual void compute(int, int) { - printf("DANGER! This function should always be overridden by child\n"); - }; - - void settings(int, char **); - virtual void coeff(int, char **); - virtual double init_one(int, int); - double memory_usage(); - - protected: - int nx, ny, nz; // global grid dimensions - int nxlo, nxhi, nylo, nyhi, nzlo, nzhi; // local grid bounds, inclusive - int ngridlocal; // number of local grid points - int nvalues; // number of values per grid point - double ****gridlocal; // local grid, redundant w.r.t. alocal - double **alocal; // pointer to Compute::array_local - int triclinic; // triclinic flag - double *boxlo, *prd; // box info (units real/ortho or reduced/tri) - double *sublo, *subhi; // subdomain info (units real/ortho or reduced/tri) - double delxinv,delyinv,delzinv; // inverse grid spacing - double delx,dely,delz; // grid spacing - int nargbase; // number of base class args - double cutmax; // largest cutoff distance - int ndesc; // number of descriptors - int ndesc_base; // number of columns used for coords, etc. - int gridlocal_allocated; // shows if gridlocal allocated - double **beta; // betas for all local grid points in list - int beta_max; // length of beta - - void allocate(); // allocate pairstyle arrays - void allocate_grid(); // create grid arrays - void deallocate_grid(); // free grid arrays - void grid2x(int, int, int, double*); // convert global indices to coordinates - void set_grid_global(); // set global grid - void set_grid_local(); // set bounds for local grid - void assign_coords(); // assign coords for grid - void copy_gridlocal_to_local_array();// copy 4d gridlocal array to 2d local array - void compute_beta(); // get betas from someplace - private: -}; - -} - -#endif -#endif - -/* ERROR/WARNING messages: - -E: Illegal ... command - -Self-explanatory. Check the input script syntax and compare to the -documentation for the command. You can use -echo screen as a -command-line option when running LAMMPS to see the offending line. - -*/ From f27e9941ae839c28f123f58df497ae2ec38acb81 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 17 Jun 2022 12:48:24 -0400 Subject: [PATCH 385/585] fix homepage urls, tabs & trailing whitespace, remove errors from headers --- doc/src/compute.rst | 4 +- doc/src/compute_sna_atom.rst | 10 +- src/ML-SNAP/compute_sna_grid.cpp | 136 ++++++++++++------------- src/ML-SNAP/compute_sna_grid.h | 18 +--- src/ML-SNAP/compute_sna_grid_local.cpp | 132 ++++++++++++------------ src/ML-SNAP/compute_sna_grid_local.h | 16 +-- src/compute_grid.cpp | 10 +- src/compute_grid.h | 14 +-- src/compute_grid_local.cpp | 46 ++++----- src/compute_grid_local.h | 14 +-- 10 files changed, 175 insertions(+), 225 deletions(-) diff --git a/doc/src/compute.rst b/doc/src/compute.rst index cf17433035..508c440e78 100644 --- a/doc/src/compute.rst +++ b/doc/src/compute.rst @@ -284,8 +284,8 @@ The individual style names on the :doc:`Commands compute ` pag * :doc:`smd/vol ` - per-particle volumes and their sum in Smooth Mach Dynamics * :doc:`snap ` - gradients of SNAP energy and forces w.r.t. linear coefficients and related quantities for fitting SNAP potentials * :doc:`sna/atom ` - bispectrum components for each atom -* :doc:`sna/grid ` - global array of bispectrum components on a regular grid -* :doc:`sna/grid/local ` - local array of bispectrum components on a regular grid +* :doc:`sna/grid ` - global array of bispectrum components on a regular grid +* :doc:`sna/grid/local ` - local array of bispectrum components on a regular grid * :doc:`snad/atom ` - derivative of bispectrum components for each atom * :doc:`snav/atom ` - virial contribution from bispectrum components for each atom * :doc:`sph/e/atom ` - per-atom internal energy of Smooth-Particle Hydrodynamics atoms diff --git a/doc/src/compute_sna_atom.rst b/doc/src/compute_sna_atom.rst index 2bbee1e6b6..5f777685fd 100644 --- a/doc/src/compute_sna_atom.rst +++ b/doc/src/compute_sna_atom.rst @@ -35,7 +35,7 @@ Syntax * twojmax = band limit for bispectrum components (non-negative integer) * R_1, R_2,... = list of cutoff radii, one for each type (distance units) * w_1, w_2,... = list of neighbor weights, one for each type -* nx, ny, nz = number of grid points in x, y, and z directions (positive integer) +* nx, ny, nz = number of grid points in x, y, and z directions (positive integer) * zero or more keyword/value pairs may be appended * keyword = *rmin0* or *switchflag* or *bzeroflag* or *quadraticflag* or *chem* or *bnormflag* or *wselfallflag* or *bikflag* or *switchinnerflag* or *sinner* or *dinner* @@ -223,7 +223,7 @@ These are calculated from the local density of nearby atoms *i'* around each grid point, as if there was a central atom *i* at the grid point. This is useful for characterizing fine-scale structure in a configuration of atoms, and it has been used -to build a machine-learning surrogate for finite-temperature Kohn-Sham +to build a machine-learning surrogate for finite-temperature Kohn-Sham density functional theory (:ref:`Ellis et al. `). Neighbor atoms not in the group do not contribute to the bispectrum components of the grid points. The distance cutoff :math:`R_{ii'}` @@ -231,7 +231,7 @@ and other parameters are defined as for a central atom with the same type as the neighbor atoms *i'*. Compute *sna/grid* calculates a global array containing bispectrum -components for a regular grid of points. +components for a regular grid of points. The grid is aligned with the current box dimensions, with the first point at the box origin, and forming a regular 3d array with *nx*, *ny*, and *nz* points in the x, y, and z directions. For triclinic @@ -720,7 +720,7 @@ The array contains one row for each of the :math:`nx \times ny \times nz` grid points, looping over the index for *ix* fastest, then *iy*, and *iz* slowest. Each row of the array contains the *x*, *y*, and *z* coordinates of the grid point, followed by the bispectrum -components. +components. Compute *sna/grid/local* evaluates a local array. The array contains one row for each of the @@ -754,7 +754,7 @@ The optional keyword defaults are *rmin0* = 0, .. _Thompson20141: **(Thompson)** Thompson, Swiler, Trott, Foiles, Tucker, J Comp Phys, 285, 316, (2015). - + .. _Bartok20101: **(Bartok)** Bartok, Payne, Risi, Csanyi, Phys Rev Lett, 104, 136403 (2010). diff --git a/src/ML-SNAP/compute_sna_grid.cpp b/src/ML-SNAP/compute_sna_grid.cpp index 1d868ba769..8247771493 100644 --- a/src/ML-SNAP/compute_sna_grid.cpp +++ b/src/ML-SNAP/compute_sna_grid.cpp @@ -1,6 +1,6 @@ /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator - http://lammps.sandia.gov, Sandia National Laboratories + https://www.lammps.org/ Sandia National Laboratories Steve Plimpton, sjplimp@sandia.gov Copyright (2003) Sandia Corporation. Under the terms of Contract @@ -41,7 +41,7 @@ ComputeSNAGrid::ComputeSNAGrid(LAMMPS *lmp, int narg, char **arg) : int twojmax, switchflag, bzeroflag, bnormflag, wselfallflag; // skip over arguments used by base class - // so that argument positions are identical to + // so that argument positions are identical to // regular per-atom compute arg += nargbase; @@ -63,7 +63,7 @@ ComputeSNAGrid::ComputeSNAGrid(LAMMPS *lmp, int narg, char **arg) : wselfallflag = 0; switchinnerflag = 0; nelements = 1; - + // process required arguments memory->create(radelem,ntypes+1,"sna/grid:radelem"); // offset by 1 to match up with types @@ -175,14 +175,14 @@ ComputeSNAGrid::ComputeSNAGrid(LAMMPS *lmp, int narg, char **arg) : if (switchinnerflag && !(sinnerflag && dinnerflag)) error->all(FLERR,"Illegal compute sna/grid command: switchinnerflag = 1, missing sinner/dinner keyword"); - + if (!switchinnerflag && (sinnerflag || dinnerflag)) error->all(FLERR,"Illegal compute sna/grid command: switchinnerflag = 0, unexpected sinner/dinner keyword"); snaptr = new SNA(lmp, rfac0, twojmax, rmin0, switchflag, bzeroflag, chemflag, bnormflag, wselfallflag, - nelements, switchinnerflag); + nelements, switchinnerflag); ncoeff = snaptr->ncoeff; nvalues = ncoeff; @@ -236,83 +236,83 @@ void ComputeSNAGrid::compute_array() const int ntotal = atom->nlocal + atom->nghost; // insure rij, inside, and typej are of size jnum - + snaptr->grow_rij(ntotal); for (int iz = nzlo; iz <= nzhi; iz++) for (int iy = nylo; iy <= nyhi; iy++) for (int ix = nxlo; ix <= nxhi; ix++) { - double xgrid[3]; - const int igrid = iz*(nx*ny) + iy*nx + ix; - grid2x(igrid, xgrid); - const double xtmp = xgrid[0]; - const double ytmp = xgrid[1]; - const double ztmp = xgrid[2]; + double xgrid[3]; + const int igrid = iz*(nx*ny) + iy*nx + ix; + grid2x(igrid, xgrid); + const double xtmp = xgrid[0]; + const double ytmp = xgrid[1]; + const double ztmp = xgrid[2]; - // currently, all grid points are type 1 - - const int itype = 1; - int ielem = 0; - if (chemflag) - ielem = map[itype]; - const double radi = radelem[itype]; + // currently, all grid points are type 1 - // rij[][3] = displacements between atom I and those neighbors - // inside = indices of neighbors of I within cutoff - // typej = types of neighbors of I within cutoff + const int itype = 1; + int ielem = 0; + if (chemflag) + ielem = map[itype]; + const double radi = radelem[itype]; - int ninside = 0; - for (int j = 0; j < ntotal; j++) { + // rij[][3] = displacements between atom I and those neighbors + // inside = indices of neighbors of I within cutoff + // typej = types of neighbors of I within cutoff - // check that j is in compute group + int ninside = 0; + for (int j = 0; j < ntotal; j++) { - if (!(mask[j] & groupbit)) continue; + // check that j is in compute group - const double delx = xtmp - x[j][0]; - const double dely = ytmp - x[j][1]; - const double delz = ztmp - x[j][2]; - const double rsq = delx*delx + dely*dely + delz*delz; - int jtype = type[j]; - int jelem = 0; - if (chemflag) + if (!(mask[j] & groupbit)) continue; + + const double delx = xtmp - x[j][0]; + const double dely = ytmp - x[j][1]; + const double delz = ztmp - x[j][2]; + const double rsq = delx*delx + dely*dely + delz*delz; + int jtype = type[j]; + int jelem = 0; + if (chemflag) jelem = map[jtype]; - if (rsq < cutsq[jtype][jtype] && rsq > 1e-20) { - snaptr->rij[ninside][0] = delx; - snaptr->rij[ninside][1] = dely; - snaptr->rij[ninside][2] = delz; - snaptr->inside[ninside] = j; - snaptr->wj[ninside] = wjelem[jtype]; - snaptr->rcutij[ninside] = 2.0*radelem[jtype]*rcutfac; - if (switchinnerflag) { - snaptr->sinnerij[ninside] = sinnerelem[jelem]; - snaptr->dinnerij[ninside] = dinnerelem[jelem]; - } - if (chemflag) snaptr->element[ninside] = jelem; - ninside++; - } - } + if (rsq < cutsq[jtype][jtype] && rsq > 1e-20) { + snaptr->rij[ninside][0] = delx; + snaptr->rij[ninside][1] = dely; + snaptr->rij[ninside][2] = delz; + snaptr->inside[ninside] = j; + snaptr->wj[ninside] = wjelem[jtype]; + snaptr->rcutij[ninside] = 2.0*radelem[jtype]*rcutfac; + if (switchinnerflag) { + snaptr->sinnerij[ninside] = sinnerelem[jelem]; + snaptr->dinnerij[ninside] = dinnerelem[jelem]; + } + if (chemflag) snaptr->element[ninside] = jelem; + ninside++; + } + } - snaptr->compute_ui(ninside, ielem); - snaptr->compute_zi(); - snaptr->compute_bi(ielem); + snaptr->compute_ui(ninside, ielem); + snaptr->compute_zi(); + snaptr->compute_bi(ielem); - // linear contributions + // linear contributions - for (int icoeff = 0; icoeff < ncoeff; icoeff++) - gridlocal[size_array_cols_base+icoeff][iz][iy][ix] = snaptr->blist[icoeff]; - - // quadratic contributions + for (int icoeff = 0; icoeff < ncoeff; icoeff++) + gridlocal[size_array_cols_base+icoeff][iz][iy][ix] = snaptr->blist[icoeff]; - if (quadraticflag) { - int ncount = ncoeff; - for (int icoeff = 0; icoeff < ncoeff; icoeff++) { - double bveci = snaptr->blist[icoeff]; - gridlocal[size_array_cols_base+ncount++][iz][iy][ix] = 0.5*bveci*bveci; - for (int jcoeff = icoeff+1; jcoeff < ncoeff; jcoeff++) - gridlocal[size_array_cols_base+ncount++][iz][iy][ix] = bveci*snaptr->blist[jcoeff]; - } - } + // quadratic contributions + + if (quadraticflag) { + int ncount = ncoeff; + for (int icoeff = 0; icoeff < ncoeff; icoeff++) { + double bveci = snaptr->blist[icoeff]; + gridlocal[size_array_cols_base+ncount++][iz][iy][ix] = 0.5*bveci*bveci; + for (int jcoeff = icoeff+1; jcoeff < ncoeff; jcoeff++) + gridlocal[size_array_cols_base+ncount++][iz][iy][ix] = bveci*snaptr->blist[jcoeff]; + } + } } memset(&grid[0][0],0,size_array_rows*size_array_cols*sizeof(double)); @@ -320,9 +320,9 @@ void ComputeSNAGrid::compute_array() for (int iz = nzlo; iz <= nzhi; iz++) for (int iy = nylo; iy <= nyhi; iy++) for (int ix = nxlo; ix <= nxhi; ix++) { - const int igrid = iz*(nx*ny) + iy*nx + ix; - for (int j = 0; j < nvalues; j++) - grid[igrid][size_array_cols_base + j] = gridlocal[size_array_cols_base + j][iz][iy][ix]; + const int igrid = iz*(nx*ny) + iy*nx + ix; + for (int j = 0; j < nvalues; j++) + grid[igrid][size_array_cols_base + j] = gridlocal[size_array_cols_base + j][iz][iy][ix]; } MPI_Allreduce(&grid[0][0],&gridall[0][0],size_array_rows*size_array_cols,MPI_DOUBLE,MPI_SUM,world); assign_coords_all(); diff --git a/src/ML-SNAP/compute_sna_grid.h b/src/ML-SNAP/compute_sna_grid.h index c203ce8bb4..9bc3da8112 100644 --- a/src/ML-SNAP/compute_sna_grid.h +++ b/src/ML-SNAP/compute_sna_grid.h @@ -1,6 +1,6 @@ /* -*- c++ -*- ---------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator - http://lammps.sandia.gov, Sandia National Laboratories + https://www.lammps.org/ Sandia National Laboratories Steve Plimpton, sjplimp@sandia.gov Copyright (2003) Sandia Corporation. Under the terms of Contract @@ -54,19 +54,3 @@ class ComputeSNAGrid : public ComputeGrid { #endif #endif - -/* ERROR/WARNING messages: - -E: Illegal ... command - -Self-explanatory. Check the input script syntax and compare to the -documentation for the command. You can use -echo screen as a -command-line option when running LAMMPS to see the offending line. - -Self-explanatory. - -W: More than one compute sna/grid - -Self-explanatory. - -*/ diff --git a/src/ML-SNAP/compute_sna_grid_local.cpp b/src/ML-SNAP/compute_sna_grid_local.cpp index 1dacc28617..70b5b362d8 100644 --- a/src/ML-SNAP/compute_sna_grid_local.cpp +++ b/src/ML-SNAP/compute_sna_grid_local.cpp @@ -1,6 +1,6 @@ /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator - http://lammps.sandia.gov, Sandia National Laboratories + https://www.lammps.org/ Sandia National Laboratories Steve Plimpton, sjplimp@sandia.gov Copyright (2003) Sandia Corporation. Under the terms of Contract @@ -41,7 +41,7 @@ ComputeSNAGridLocal::ComputeSNAGridLocal(LAMMPS *lmp, int narg, char **arg) : int twojmax, switchflag, bzeroflag, bnormflag, wselfallflag; // skip over arguments used by base class - // so that argument positions are identical to + // so that argument positions are identical to // regular per-atom compute arg += nargbase; @@ -63,7 +63,7 @@ ComputeSNAGridLocal::ComputeSNAGridLocal(LAMMPS *lmp, int narg, char **arg) : wselfallflag = 0; switchinnerflag = 0; nelements = 1; - + // set local input checks int sinnerflag = 0; @@ -175,14 +175,14 @@ ComputeSNAGridLocal::ComputeSNAGridLocal(LAMMPS *lmp, int narg, char **arg) : if (switchinnerflag && !(sinnerflag && dinnerflag)) error->all(FLERR,"Illegal compute sna/grid/local command: switchinnerflag = 1, missing sinner/dinner keyword"); - + if (!switchinnerflag && (sinnerflag || dinnerflag)) error->all(FLERR,"Illegal compute sna/grid/local command: switchinnerflag = 0, unexpected sinner/dinner keyword"); snaptr = new SNA(lmp, rfac0, twojmax, rmin0, switchflag, bzeroflag, chemflag, bnormflag, wselfallflag, - nelements, switchinnerflag); + nelements, switchinnerflag); ncoeff = snaptr->ncoeff; nvalues = ncoeff; @@ -235,84 +235,84 @@ void ComputeSNAGridLocal::compute_local() const int ntotal = atom->nlocal + atom->nghost; // insure rij, inside, and typej are of size jnum - + snaptr->grow_rij(ntotal); int igrid = 0; for (int iz = nzlo; iz <= nzhi; iz++) for (int iy = nylo; iy <= nyhi; iy++) for (int ix = nxlo; ix <= nxhi; ix++) { - double xgrid[3]; - grid2x(ix, iy, iz, xgrid); - const double xtmp = xgrid[0]; - const double ytmp = xgrid[1]; - const double ztmp = xgrid[2]; + double xgrid[3]; + grid2x(ix, iy, iz, xgrid); + const double xtmp = xgrid[0]; + const double ytmp = xgrid[1]; + const double ztmp = xgrid[2]; - // currently, all grid points are type 1 - - const int itype = 1; - int ielem = 0; - if (chemflag) - ielem = map[itype]; - const double radi = radelem[itype]; + // currently, all grid points are type 1 - // rij[][3] = displacements between atom I and those neighbors - // inside = indices of neighbors of I within cutoff - // typej = types of neighbors of I within cutoff + const int itype = 1; + int ielem = 0; + if (chemflag) + ielem = map[itype]; + const double radi = radelem[itype]; - int ninside = 0; - for (int j = 0; j < ntotal; j++) { + // rij[][3] = displacements between atom I and those neighbors + // inside = indices of neighbors of I within cutoff + // typej = types of neighbors of I within cutoff - // check that j is in compute group + int ninside = 0; + for (int j = 0; j < ntotal; j++) { - if (!(mask[j] & groupbit)) continue; + // check that j is in compute group - const double delx = xtmp - x[j][0]; - const double dely = ytmp - x[j][1]; - const double delz = ztmp - x[j][2]; - const double rsq = delx*delx + dely*dely + delz*delz; - int jtype = type[j]; - int jelem = 0; - if (chemflag) - jelem = map[jtype]; - if (rsq < cutsq[jtype][jtype] && rsq > 1e-20) { - snaptr->rij[ninside][0] = delx; - snaptr->rij[ninside][1] = dely; - snaptr->rij[ninside][2] = delz; - snaptr->inside[ninside] = j; - snaptr->wj[ninside] = wjelem[jtype]; - snaptr->rcutij[ninside] = 2.0*radelem[jtype]*rcutfac; - if (switchinnerflag) { - snaptr->sinnerij[ninside] = sinnerelem[jelem]; - snaptr->dinnerij[ninside] = dinnerelem[jelem]; - } - if (chemflag) snaptr->element[ninside] = jelem; // element index for multi-element snap - ninside++; - } - } + if (!(mask[j] & groupbit)) continue; - snaptr->compute_ui(ninside, ielem); - snaptr->compute_zi(); - snaptr->compute_bi(ielem); + const double delx = xtmp - x[j][0]; + const double dely = ytmp - x[j][1]; + const double delz = ztmp - x[j][2]; + const double rsq = delx*delx + dely*dely + delz*delz; + int jtype = type[j]; + int jelem = 0; + if (chemflag) + jelem = map[jtype]; + if (rsq < cutsq[jtype][jtype] && rsq > 1e-20) { + snaptr->rij[ninside][0] = delx; + snaptr->rij[ninside][1] = dely; + snaptr->rij[ninside][2] = delz; + snaptr->inside[ninside] = j; + snaptr->wj[ninside] = wjelem[jtype]; + snaptr->rcutij[ninside] = 2.0*radelem[jtype]*rcutfac; + if (switchinnerflag) { + snaptr->sinnerij[ninside] = sinnerelem[jelem]; + snaptr->dinnerij[ninside] = dinnerelem[jelem]; + } + if (chemflag) snaptr->element[ninside] = jelem; // element index for multi-element snap + ninside++; + } + } - // linear contributions + snaptr->compute_ui(ninside, ielem); + snaptr->compute_zi(); + snaptr->compute_bi(ielem); - for (int icoeff = 0; icoeff < ncoeff; icoeff++) - alocal[igrid][size_local_cols_base+icoeff] = snaptr->blist[icoeff]; + // linear contributions - // quadratic contributions + for (int icoeff = 0; icoeff < ncoeff; icoeff++) + alocal[igrid][size_local_cols_base+icoeff] = snaptr->blist[icoeff]; - if (quadraticflag) { - int ncount = ncoeff; - for (int icoeff = 0; icoeff < ncoeff; icoeff++) { - double bveci = snaptr->blist[icoeff]; - alocal[igrid][size_local_cols_base+ncount++] = 0.5*bveci*bveci; - for (int jcoeff = icoeff+1; jcoeff < ncoeff; jcoeff++) - alocal[igrid][size_local_cols_base+ncount++] = - bveci*snaptr->blist[jcoeff]; - } - } - igrid++; + // quadratic contributions + + if (quadraticflag) { + int ncount = ncoeff; + for (int icoeff = 0; icoeff < ncoeff; icoeff++) { + double bveci = snaptr->blist[icoeff]; + alocal[igrid][size_local_cols_base+ncount++] = 0.5*bveci*bveci; + for (int jcoeff = icoeff+1; jcoeff < ncoeff; jcoeff++) + alocal[igrid][size_local_cols_base+ncount++] = + bveci*snaptr->blist[jcoeff]; + } + } + igrid++; } } diff --git a/src/ML-SNAP/compute_sna_grid_local.h b/src/ML-SNAP/compute_sna_grid_local.h index 5ce40069ee..69a2c528fc 100644 --- a/src/ML-SNAP/compute_sna_grid_local.h +++ b/src/ML-SNAP/compute_sna_grid_local.h @@ -1,6 +1,6 @@ /* -*- c++ -*- ---------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator - http://lammps.sandia.gov, Sandia National Laboratories + https://www.lammps.org/ Sandia National Laboratories Steve Plimpton, sjplimp@sandia.gov Copyright (2003) Sandia Corporation. Under the terms of Contract @@ -54,17 +54,3 @@ class ComputeSNAGridLocal : public ComputeGridLocal { #endif #endif - -/* ERROR/WARNING messages: - -E: Illegal ... command - -Self-explanatory. Check the input script syntax and compare to the -documentation for the command. You can use -echo screen as a -command-line option when running LAMMPS to see the offending line. - -W: More than one compute sna/grid/local - -Self-explanatory. - -*/ diff --git a/src/compute_grid.cpp b/src/compute_grid.cpp index dd21b731e8..60c9987cbc 100644 --- a/src/compute_grid.cpp +++ b/src/compute_grid.cpp @@ -1,6 +1,6 @@ /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator - http://lammps.sandia.gov, Sandia National Laboratories + https://www.lammps.org/ Sandia National Laboratories Steve Plimpton, sjplimp@sandia.gov Copyright (2003) Sandia Corporation. Under the terms of Contract @@ -128,7 +128,7 @@ void ComputeGrid::allocate() if (nxlo <= nxhi && nylo <= nyhi && nzlo <= nzhi) { gridlocal_allocated = 1; memory->create4d_offset(gridlocal,size_array_cols,nzlo,nzhi,nylo,nyhi, - nxlo,nxhi,"grid:gridlocal"); + nxlo,nxhi,"grid:gridlocal"); } array = gridall; } @@ -179,7 +179,7 @@ void ComputeGrid::set_grid_global() delxinv = nx/xprd; delyinv = ny/yprd; delzinv = nz/zprd; - + delx = 1.0/delxinv; dely = 1.0/delyinv; delz = 1.0/delzinv; @@ -245,9 +245,9 @@ void ComputeGrid::set_grid_local() double ComputeGrid::memory_usage() { - double nbytes = size_array_rows*size_array_cols * + double nbytes = size_array_rows*size_array_cols * sizeof(double); // grid - nbytes += size_array_rows*size_array_cols * + nbytes += size_array_rows*size_array_cols * sizeof(double); // gridall nbytes += size_array_cols*ngridlocal*sizeof(double); // gridlocal return nbytes; diff --git a/src/compute_grid.h b/src/compute_grid.h index 7bda1a89fa..b0214b2b15 100644 --- a/src/compute_grid.h +++ b/src/compute_grid.h @@ -1,6 +1,6 @@ /* -*- c++ -*- ---------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator - http://lammps.sandia.gov, Sandia National Laboratories + https://www.lammps.org/ Sandia National Laboratories Steve Plimpton, sjplimp@sandia.gov Copyright (2003) Sandia Corporation. Under the terms of Contract @@ -42,7 +42,7 @@ class ComputeGrid : public Compute { double *sublo, *subhi; // subdomain info (units real/ortho or reduced/tri) double delxinv,delyinv,delzinv; // inverse grid spacing double delx,dely,delz; // grid spacing - int nargbase; // number of base class args + int nargbase; // number of base class args double cutmax; // largest cutoff distance int size_array_cols_base; // number of columns used for coords, etc. int gridlocal_allocated; // shows if gridlocal allocated @@ -59,13 +59,3 @@ class ComputeGrid : public Compute { } #endif - -/* ERROR/WARNING messages: - -E: Illegal ... command - -Self-explanatory. Check the input script syntax and compare to the -documentation for the command. You can use -echo screen as a -command-line option when running LAMMPS to see the offending line. - -*/ diff --git a/src/compute_grid_local.cpp b/src/compute_grid_local.cpp index bcc56c3abd..e30d06fe45 100644 --- a/src/compute_grid_local.cpp +++ b/src/compute_grid_local.cpp @@ -1,6 +1,6 @@ /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator - http://lammps.sandia.gov, Sandia National Laboratories + https://www.lammps.org/ Sandia National Laboratories Steve Plimpton, sjplimp@sandia.gov Copyright (2003) Sandia Corporation. Under the terms of Contract @@ -164,7 +164,7 @@ void ComputeGridLocal::set_grid_global() delxinv = nx/xprd; delyinv = ny/yprd; delzinv = nz/zprd; - + delx = 1.0/delxinv; dely = 1.0/delyinv; delz = 1.0/delzinv; @@ -233,34 +233,34 @@ void ComputeGridLocal::assign_coords() for (int iz = nzlo; iz <= nzhi; iz++) for (int iy = nylo; iy <= nyhi; iy++) for (int ix = nxlo; ix <= nxhi; ix++) { - alocal[igrid][0] = ix; - alocal[igrid][1] = iy; - alocal[igrid][2] = iz; - double xgrid[3]; + alocal[igrid][0] = ix; + alocal[igrid][1] = iy; + alocal[igrid][2] = iz; + double xgrid[3]; - // for triclinic: create gridpoint in lamda coordinates and transform after check. - // for orthorombic: create gridpoint in box coordinates. + // for triclinic: create gridpoint in lamda coordinates and transform after check. + // for orthorombic: create gridpoint in box coordinates. - if (triclinic) - grid2lamda(ix, iy, iz, xgrid); - else - grid2x(ix, iy, iz, xgrid); + if (triclinic) + grid2lamda(ix, iy, iz, xgrid); + else + grid2x(ix, iy, iz, xgrid); - // ensure gridpoint is not strictly outside subdomain + // ensure gridpoint is not strictly outside subdomain - if ((sublo[0]-xgrid[0]) > EPSILON || (xgrid[0]-subhi[0]) > EPSILON || - (sublo[1]-xgrid[1]) > EPSILON || (xgrid[1]-subhi[1]) > EPSILON || - (sublo[2]-xgrid[2]) > EPSILON || (xgrid[2]-subhi[2]) > EPSILON) - error->one(FLERR,"Invalid gridpoint position in compute grid/local"); + if ((sublo[0]-xgrid[0]) > EPSILON || (xgrid[0]-subhi[0]) > EPSILON || + (sublo[1]-xgrid[1]) > EPSILON || (xgrid[1]-subhi[1]) > EPSILON || + (sublo[2]-xgrid[2]) > EPSILON || (xgrid[2]-subhi[2]) > EPSILON) + error->one(FLERR,"Invalid gridpoint position in compute grid/local"); - // convert lamda to x, y, z, after sudomain check + // convert lamda to x, y, z, after sudomain check - if (triclinic) domain->lamda2x(xgrid, xgrid); + if (triclinic) domain->lamda2x(xgrid, xgrid); - alocal[igrid][3] = xgrid[0]; - alocal[igrid][4] = xgrid[1]; - alocal[igrid][5] = xgrid[2]; - igrid++; + alocal[igrid][3] = xgrid[0]; + alocal[igrid][4] = xgrid[1]; + alocal[igrid][5] = xgrid[2]; + igrid++; } } diff --git a/src/compute_grid_local.h b/src/compute_grid_local.h index 15ea8ca47f..5c5611250b 100644 --- a/src/compute_grid_local.h +++ b/src/compute_grid_local.h @@ -1,6 +1,6 @@ /* -*- c++ -*- ---------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator - http://lammps.sandia.gov, Sandia National Laboratories + https://www.lammps.org/ Sandia National Laboratories Steve Plimpton, sjplimp@sandia.gov Copyright (2003) Sandia Corporation. Under the terms of Contract @@ -39,7 +39,7 @@ class ComputeGridLocal : public Compute { double *sublo, *subhi; // subdomain info (units real/ortho or reduced/tri) double delxinv,delyinv,delzinv; // inverse grid spacing double delx,dely,delz; // grid spacing - int nargbase; // number of base class args + int nargbase; // number of base class args double cutmax; // largest cutoff distance int size_local_cols_base; // number of columns used for coords, etc. int gridlocal_allocated; // shows if gridlocal allocated @@ -57,13 +57,3 @@ class ComputeGridLocal : public Compute { } #endif - -/* ERROR/WARNING messages: - -E: Illegal ... command - -Self-explanatory. Check the input script syntax and compare to the -documentation for the command. You can use -echo screen as a -command-line option when running LAMMPS to see the offending line. - -*/ From 185d5cdc0fda9d6511b3084ff718998aff7eba09 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 17 Jun 2022 12:50:54 -0400 Subject: [PATCH 386/585] update .gitignore --- src/.gitignore | 4 ++++ 1 file changed, 4 insertions(+) diff --git a/src/.gitignore b/src/.gitignore index de157734fc..198dcdc290 100644 --- a/src/.gitignore +++ b/src/.gitignore @@ -179,6 +179,10 @@ /compute_snad_atom.h /compute_snav_atom.cpp /compute_snav_atom.h +/compute_sna_grid.cpp +/compute_sna_grid.h +/compute_sna_grid_local.cpp +/compute_sna_grid_local.h /compute_snap.cpp /compute_snap.h /openmp_snap.h From db3363649a9765a8dd6043132221a3bb0553cc7b Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Fri, 17 Jun 2022 11:00:59 -0600 Subject: [PATCH 387/585] dated example files --- examples/mdi/README | 55 +- examples/mdi/Run.sh | 8 +- examples/mdi/dump.17Jun22.series.alone.1 | 1527 +++++++++++++ examples/mdi/dump.17Jun22.series.driver.mpi.1 | 1527 +++++++++++++ examples/mdi/dump.17Jun22.series.driver.mpi.4 | 1527 +++++++++++++ .../mdi/dump.17Jun22.series.driver.plugin.1 | 1527 +++++++++++++ .../mdi/dump.17Jun22.series.driver.plugin.3 | 1527 +++++++++++++ examples/mdi/dump.17Jun22.series.driver.tcp.1 | 1527 +++++++++++++ examples/mdi/dump.17Jun22.series.driver.tcp.4 | 1527 +++++++++++++ examples/mdi/dump.17Jun22.snapshot.alone.1 | 2036 +++++++++++++++++ .../mdi/dump.17Jun22.snapshot.driver.mpi.1 | 2036 +++++++++++++++++ .../mdi/dump.17Jun22.snapshot.driver.mpi.4 | 2036 +++++++++++++++++ .../mdi/dump.17Jun22.snapshot.driver.plugin.1 | 2036 +++++++++++++++++ .../mdi/dump.17Jun22.snapshot.driver.plugin.3 | 2036 +++++++++++++++++ .../mdi/dump.17Jun22.snapshot.driver.tcp.1 | 2036 +++++++++++++++++ .../mdi/dump.17Jun22.snapshot.driver.tcp.4 | 2036 +++++++++++++++++ examples/mdi/log.17Jun22.aimd.alone.1 | 95 + examples/mdi/log.17Jun22.aimd.driver.mpi.1 | 83 + examples/mdi/log.17Jun22.aimd.driver.mpi.3 | 83 + examples/mdi/log.17Jun22.aimd.driver.plugin.1 | 84 + examples/mdi/log.17Jun22.aimd.driver.plugin.3 | 84 + examples/mdi/log.17Jun22.aimd.driver.tcp.1 | 83 + examples/mdi/log.17Jun22.aimd.driver.tcp.3 | 83 + examples/mdi/log.17Jun22.aimd.engine.mpi.1 | 55 + examples/mdi/log.17Jun22.aimd.engine.mpi.4 | 55 + examples/mdi/log.17Jun22.aimd.engine.plugin.1 | 55 + examples/mdi/log.17Jun22.aimd.engine.plugin.3 | 55 + examples/mdi/log.17Jun22.aimd.engine.tcp.1 | 55 + examples/mdi/log.17Jun22.aimd.engine.tcp.4 | 55 + examples/mdi/log.17Jun22.aimdpy.driver.mpi.1 | 77 + examples/mdi/log.17Jun22.aimdpy.driver.mpi.2 | 77 + examples/mdi/log.17Jun22.aimdpy.driver.tcp.1 | 11 + examples/mdi/log.17Jun22.aimdpy.driver.tcp.2 | 11 + examples/mdi/log.17Jun22.aimdpy.mm.mpi.1 | 49 + examples/mdi/log.17Jun22.aimdpy.mm.mpi.2 | 49 + examples/mdi/log.17Jun22.aimdpy.mm.tcp.1 | 49 + examples/mdi/log.17Jun22.aimdpy.mm.tcp.2 | 49 + examples/mdi/log.17Jun22.aimdpy.qm.mpi.1 | 60 + examples/mdi/log.17Jun22.aimdpy.qm.mpi.3 | 60 + examples/mdi/log.17Jun22.aimdpy.qm.tcp.1 | 60 + examples/mdi/log.17Jun22.aimdpy.qm.tcp.3 | 60 + .../mdi/log.17Jun22.sequence.engine.mpi.1 | 90 + .../mdi/log.17Jun22.sequence.engine.mpi.4 | 90 + .../mdi/log.17Jun22.sequence.engine.plugin.1 | 90 + .../mdi/log.17Jun22.sequence.engine.plugin.3 | 90 + .../mdi/log.17Jun22.sequence.engine.tcp.1 | 90 + .../mdi/log.17Jun22.sequence.engine.tcp.4 | 90 + examples/mdi/log.17Jun22.series.alone.1 | 248 ++ examples/mdi/log.17Jun22.series.driver.mpi.1 | 213 ++ examples/mdi/log.17Jun22.series.driver.mpi.3 | 213 ++ .../mdi/log.17Jun22.series.driver.plugin.1 | 212 ++ .../mdi/log.17Jun22.series.driver.plugin.3 | 212 ++ examples/mdi/log.17Jun22.series.driver.tcp.1 | 213 ++ examples/mdi/log.17Jun22.series.driver.tcp.3 | 213 ++ examples/mdi/log.17Jun22.series.engine.mpi.1 | 58 + examples/mdi/log.17Jun22.series.engine.mpi.4 | 58 + .../mdi/log.17Jun22.series.engine.plugin.1 | 42 + .../mdi/log.17Jun22.series.engine.plugin.3 | 42 + examples/mdi/log.17Jun22.series.engine.tcp.1 | 58 + examples/mdi/log.17Jun22.series.engine.tcp.4 | 58 + examples/mdi/log.17Jun22.snapshot.alone.1 | 82 + .../mdi/log.17Jun22.snapshot.driver.mpi.1 | 105 + .../mdi/log.17Jun22.snapshot.driver.mpi.3 | 105 + .../mdi/log.17Jun22.snapshot.driver.plugin.1 | 118 + .../mdi/log.17Jun22.snapshot.driver.plugin.3 | 118 + .../mdi/log.17Jun22.snapshot.driver.tcp.1 | 105 + .../mdi/log.17Jun22.snapshot.driver.tcp.3 | 105 + .../mdi/log.17Jun22.snapshot.engine.mpi.1 | 45 + .../mdi/log.17Jun22.snapshot.engine.mpi.3 | 45 + .../mdi/log.17Jun22.snapshot.engine.plugin.1 | 45 + .../mdi/log.17Jun22.snapshot.engine.plugin.3 | 45 + .../mdi/log.17Jun22.snapshot.engine.tcp.1 | 45 + .../mdi/log.17Jun22.snapshot.engine.tcp.4 | 45 + 73 files changed, 29906 insertions(+), 23 deletions(-) create mode 100644 examples/mdi/dump.17Jun22.series.alone.1 create mode 100644 examples/mdi/dump.17Jun22.series.driver.mpi.1 create mode 100644 examples/mdi/dump.17Jun22.series.driver.mpi.4 create mode 100644 examples/mdi/dump.17Jun22.series.driver.plugin.1 create mode 100644 examples/mdi/dump.17Jun22.series.driver.plugin.3 create mode 100644 examples/mdi/dump.17Jun22.series.driver.tcp.1 create mode 100644 examples/mdi/dump.17Jun22.series.driver.tcp.4 create mode 100644 examples/mdi/dump.17Jun22.snapshot.alone.1 create mode 100644 examples/mdi/dump.17Jun22.snapshot.driver.mpi.1 create mode 100644 examples/mdi/dump.17Jun22.snapshot.driver.mpi.4 create mode 100644 examples/mdi/dump.17Jun22.snapshot.driver.plugin.1 create mode 100644 examples/mdi/dump.17Jun22.snapshot.driver.plugin.3 create mode 100644 examples/mdi/dump.17Jun22.snapshot.driver.tcp.1 create mode 100644 examples/mdi/dump.17Jun22.snapshot.driver.tcp.4 create mode 100644 examples/mdi/log.17Jun22.aimd.alone.1 create mode 100644 examples/mdi/log.17Jun22.aimd.driver.mpi.1 create mode 100644 examples/mdi/log.17Jun22.aimd.driver.mpi.3 create mode 100644 examples/mdi/log.17Jun22.aimd.driver.plugin.1 create mode 100644 examples/mdi/log.17Jun22.aimd.driver.plugin.3 create mode 100644 examples/mdi/log.17Jun22.aimd.driver.tcp.1 create mode 100644 examples/mdi/log.17Jun22.aimd.driver.tcp.3 create mode 100644 examples/mdi/log.17Jun22.aimd.engine.mpi.1 create mode 100644 examples/mdi/log.17Jun22.aimd.engine.mpi.4 create mode 100644 examples/mdi/log.17Jun22.aimd.engine.plugin.1 create mode 100644 examples/mdi/log.17Jun22.aimd.engine.plugin.3 create mode 100644 examples/mdi/log.17Jun22.aimd.engine.tcp.1 create mode 100644 examples/mdi/log.17Jun22.aimd.engine.tcp.4 create mode 100644 examples/mdi/log.17Jun22.aimdpy.driver.mpi.1 create mode 100644 examples/mdi/log.17Jun22.aimdpy.driver.mpi.2 create mode 100644 examples/mdi/log.17Jun22.aimdpy.driver.tcp.1 create mode 100644 examples/mdi/log.17Jun22.aimdpy.driver.tcp.2 create mode 100644 examples/mdi/log.17Jun22.aimdpy.mm.mpi.1 create mode 100644 examples/mdi/log.17Jun22.aimdpy.mm.mpi.2 create mode 100644 examples/mdi/log.17Jun22.aimdpy.mm.tcp.1 create mode 100644 examples/mdi/log.17Jun22.aimdpy.mm.tcp.2 create mode 100644 examples/mdi/log.17Jun22.aimdpy.qm.mpi.1 create mode 100644 examples/mdi/log.17Jun22.aimdpy.qm.mpi.3 create mode 100644 examples/mdi/log.17Jun22.aimdpy.qm.tcp.1 create mode 100644 examples/mdi/log.17Jun22.aimdpy.qm.tcp.3 create mode 100644 examples/mdi/log.17Jun22.sequence.engine.mpi.1 create mode 100644 examples/mdi/log.17Jun22.sequence.engine.mpi.4 create mode 100644 examples/mdi/log.17Jun22.sequence.engine.plugin.1 create mode 100644 examples/mdi/log.17Jun22.sequence.engine.plugin.3 create mode 100644 examples/mdi/log.17Jun22.sequence.engine.tcp.1 create mode 100644 examples/mdi/log.17Jun22.sequence.engine.tcp.4 create mode 100644 examples/mdi/log.17Jun22.series.alone.1 create mode 100644 examples/mdi/log.17Jun22.series.driver.mpi.1 create mode 100644 examples/mdi/log.17Jun22.series.driver.mpi.3 create mode 100644 examples/mdi/log.17Jun22.series.driver.plugin.1 create mode 100644 examples/mdi/log.17Jun22.series.driver.plugin.3 create mode 100644 examples/mdi/log.17Jun22.series.driver.tcp.1 create mode 100644 examples/mdi/log.17Jun22.series.driver.tcp.3 create mode 100644 examples/mdi/log.17Jun22.series.engine.mpi.1 create mode 100644 examples/mdi/log.17Jun22.series.engine.mpi.4 create mode 100644 examples/mdi/log.17Jun22.series.engine.plugin.1 create mode 100644 examples/mdi/log.17Jun22.series.engine.plugin.3 create mode 100644 examples/mdi/log.17Jun22.series.engine.tcp.1 create mode 100644 examples/mdi/log.17Jun22.series.engine.tcp.4 create mode 100644 examples/mdi/log.17Jun22.snapshot.alone.1 create mode 100644 examples/mdi/log.17Jun22.snapshot.driver.mpi.1 create mode 100644 examples/mdi/log.17Jun22.snapshot.driver.mpi.3 create mode 100644 examples/mdi/log.17Jun22.snapshot.driver.plugin.1 create mode 100644 examples/mdi/log.17Jun22.snapshot.driver.plugin.3 create mode 100644 examples/mdi/log.17Jun22.snapshot.driver.tcp.1 create mode 100644 examples/mdi/log.17Jun22.snapshot.driver.tcp.3 create mode 100644 examples/mdi/log.17Jun22.snapshot.engine.mpi.1 create mode 100644 examples/mdi/log.17Jun22.snapshot.engine.mpi.3 create mode 100644 examples/mdi/log.17Jun22.snapshot.engine.plugin.1 create mode 100644 examples/mdi/log.17Jun22.snapshot.engine.plugin.3 create mode 100644 examples/mdi/log.17Jun22.snapshot.engine.tcp.1 create mode 100644 examples/mdi/log.17Jun22.snapshot.engine.tcp.4 diff --git a/examples/mdi/README b/examples/mdi/README index 9ab3a3baf6..4976e33f00 100644 --- a/examples/mdi/README +++ b/examples/mdi/README @@ -19,7 +19,8 @@ LAMMPS supports operating in all these MDI modes. It can be an engine operating either as a stand-alone code or as a plugin. It can also be a driver and couple to an engine that is either a stand-alone code or a plugin. Examples for all these use cases are in this directory. -The example commands below illustrate how to run all the variants. +The Run.sh file shows how run in all the modes. Type "sh Run.sh" +to try them all out. To use LAMMPS as a plugin engine, you must build it as a shared library. Something like this with make, which also builds the normal @@ -33,10 +34,7 @@ To use the serial_driver.py example you will need Python 3 with Numpy and mpi4py available in your Python. Make sure LAMMPS and Python are using same the same version of MPI. -5 use-case examples are explained below. - -See the Run.sh file for commands to run each of the examples -in all the different modes. Type "sh Run.sh" to run them all. +5 example use-cases are explained below. In the first 3 examples, results running with MDI should be identical to running without MDI (alone log files). Example #4 has no non-MDI @@ -47,43 +45,52 @@ run. Example #5 results should match the non-MDI run of example #1. * Example #1 = run ab initio MD (AIMD) -See the log aimd files. - Two instances of LAMMPS operate as a driver and engine. As an engine, LAMMPS is a surrogate for a quantum code. -Note that the 2 input scripts in.aimd.alone and in.aimd.driver -have an option for running in NVE vs NPT mode. Comment in/out -the appropriate line to change modes. Nothing needs to be -changed in the in.aimd.engine or in.aimd.engine.plugin scripts. +You can compare the thermo output in log.aimd.alone.1 to the thermo output in +any of the log.aimd.driver* files. It should be identical. + +Note that the "alone" and "driver" input scripts have options for +running in NVE vs NPT Comment in/out the appropriate line to make +change. Nothing needs to be changed in the "engine" scripts. ------------------------------------------------- ------------------------------------------------- * Example #2 = run LAMMPS, compute QM forces on snapshots from a long run -See the log snapshot and dump snapshot files. - Two instances of LAMMPS operate as a driver and engine. As an engine, LAMMPS is a surrogate for a quantum code +You can compare the thermo output in log.snapshot.alone.1 to the +thermo output in any of the log.snapshot.driver* files. It should be +identical. + +You can compare the dumped forces in dump.snapshot.alone.1 to the +forces in any of the dump.snapshot.* files. They should be identical, +although at step 0 the forces are "zero" and may be epsilon different. + ------------------------------------------------- ------------------------------------------------- * Example #3 = run LAMMPS, compute QM forces on series of independent systems -files See the log series and dump series files. - Two instances of LAMMPS operate as a driver and engine. As an engine, LAMMPS is a surrogate for a quantum code +You can compare the thermo output in log.series.alone.1 to the thermo +output in any of the log.series.driver* files. It should be +identical. + +You can compare the dumped forces in dump.series.alone.1 to the forces +in any of the dump.series.* files. They should be identical, + ------------------------------------------------- ------------------------------------------------- * Example #4 = Python driver runs a sequence of unrelated LAMMPS calculations -See the log sequence files. - Each calculation can be a single-point evaluation, MD run, or minimization @@ -114,13 +121,14 @@ copied here: # -seed 12345 # random number seed > 0, default = 12345 +You can compare the thermo output in any of the log.sequence.engine.* +files. It should be identical. + ------------------------------------------------- ------------------------------------------------- * Example #5 = run AIMD with Python driver code and 2 LAMMPS instances as engines -See the log aimdpy files. - First LAMMPS instance performs the MD timestepping. Second LAMMPS instance is surrogate QM to compute forces. @@ -132,3 +140,12 @@ switch is also explained the top of the file; the info is copied here: # -nsteps 10 # number of timesteps in dynamics runs, default = 10 + +This calculation is the same as Example #1 with a LAMMPS driver and a +LAMMPS engine. Now there is a Python driver and two LAMMPS engines. + +You can compare the thermo output in log.aimd.alone.1 output to the +thermo output is any of the log.sequence.engine.* files. It should be +identical for the Total Energy printed out by the Python driver script. + +E.g. Step 10: MM energy 1.69875, QM energy -6.31535, Total energy -4.6166 diff --git a/examples/mdi/Run.sh b/examples/mdi/Run.sh index 934b25d4e1..3817841103 100644 --- a/examples/mdi/Run.sh +++ b/examples/mdi/Run.sh @@ -81,7 +81,7 @@ mv dump.snapshot.driver dump.snapshot.driver.tcp.1 mpirun -np 3 lmp_mpi -mdi "-name LMP1 -role DRIVER -method TCP -port 8021" -log log.snapshot.driver.tcp.3 -in in.snapshot.driver & mpirun -np 4 lmp_mpi -mdi "-name LMP2 -role ENGINE -method TCP -port 8021 -hostname localhost" -log log.snapshot.engine.tcp.4 -in in.snapshot.engine -mv dump.snapshot.driver dump.snapshot.driver.tcp.3 +mv dump.snapshot.driver dump.snapshot.driver.tcp.4 # --- @@ -95,7 +95,7 @@ mv dump.snapshot.driver dump.snapshot.driver.mpi.1 # Run with MPI: 3 procs + 4 procs mpirun -np 3 lmp_mpi -mdi "-name LMP1 -role DRIVER -method MPI" -log log.snapshot.driver.mpi.3 -in in.snapshot.driver : -np 4 lmp_mpi -mdi "-name LMP2 -role ENGINE -method MPI" -log log.snapshot.engine.mpi.3 -in in.snapshot.engine -mv dump.snapshot.driver dump.snapshot.driver.mpi.3 +mv dump.snapshot.driver dump.snapshot.driver.mpi.4 # --- @@ -141,7 +141,7 @@ mv dump.series.driver dump.series.driver.tcp.1 mpirun -np 3 lmp_mpi -mdi "-name LMP1 -role DRIVER -method TCP -port 8021" -log log.series.driver.tcp.3 -in in.series.driver & mpirun -np 4 lmp_mpi -mdi "-name LMP2 -role ENGINE -method TCP -port 8021 -hostname localhost" -log log.series.engine.tcp.4 -in in.series.engine -mv dump.series.driver dump.series.driver.tcp.3 +mv dump.series.driver dump.series.driver.tcp.4 # --- @@ -155,7 +155,7 @@ mv dump.series.driver dump.series.driver.mpi.1 # Run with MPI: 3 procs + 4 procs mpirun -np 3 lmp_mpi -mdi "-name LMP1 -role DRIVER -method MPI" -log log.series.driver.mpi.3 -in in.series.driver : -np 4 lmp_mpi -mdi "-name LMP2 -role ENGINE -method MPI" -log log.series.engine.mpi.4 -in in.series.engine -mv dump.series.driver dump.series.driver.mpi.3 +mv dump.series.driver dump.series.driver.mpi.4 # --- diff --git a/examples/mdi/dump.17Jun22.series.alone.1 b/examples/mdi/dump.17Jun22.series.alone.1 new file mode 100644 index 0000000000..0184de5802 --- /dev/null +++ b/examples/mdi/dump.17Jun22.series.alone.1 @@ -0,0 +1,1527 @@ +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +500 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 8.9390353509656766e+00 +0.0000000000000000e+00 8.9390353509656766e+00 +0.0000000000000000e+00 8.9390353509656766e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 0.0109462 8.91109 8.87705 -0.258023 0.625273 0.429284 +2 1 0.983178 0.93542 8.91066 -2.88593 0.281032 -1.95154 +3 1 0.886776 0.00353842 0.964105 -0.27179 0.383251 0.443719 +4 1 0.0722273 0.817966 0.815708 -0.663834 1.25489 -0.35451 +5 1 1.82919 8.8603 8.91164 0.346262 0.966337 0.327185 +6 1 2.71374 0.850558 0.0977971 -1.53533 0.952301 -0.539148 +7 1 2.75443 8.9152 0.943835 0.200679 -0.0265554 -0.862232 +8 1 1.72161 0.971413 0.796705 7.79754 -6.0811 1.58835 +9 1 3.47837 0.0294075 0.0515782 2.76325 -2.21894 -0.80311 +10 1 4.43186 0.961325 8.89919 -0.387918 -0.444884 0.950878 +11 1 4.37764 0.00631327 0.801109 0.844344 -0.87322 -0.116598 +12 1 3.59567 0.80748 0.974874 -0.705778 1.85625 -1.80855 +13 1 5.35026 8.89566 0.0208816 -0.442875 -0.272596 -0.473028 +14 1 6.3022 0.978028 0.0782288 -3.05518 -2.94099 -0.889505 +15 1 6.27707 0.0297536 0.962734 -0.0515917 0.772188 -1.05602 +16 1 5.30223 0.918655 0.899444 1.33545 0.759601 -1.29769 +17 1 7.0769 0.0948096 0.0649153 0.098645 -1.06535 0.292165 +18 1 8.09537 0.913626 0.0774105 -0.154847 0.414543 -0.451754 +19 1 8.08165 0.0818588 0.895196 -0.689773 -1.28143 0.929968 +20 1 7.14638 0.885276 0.891299 0.487793 0.733541 0.918445 +21 1 8.89456 1.84483 0.0434425 0.886905 -0.621358 -0.495646 +22 1 0.935681 2.64324 0.0406455 -1.34335 0.213362 -1.25695 +23 1 0.966071 1.69976 0.948945 -7.88058 11.3257 -7.25569 +24 1 0.0121607 2.66637 0.881115 -0.232812 0.533689 1.18415 +25 1 1.85044 1.81859 0.00192994 -1.7495 0.19048 0.1992 +26 1 2.68148 2.7251 0.0685109 -1.25528 -0.916148 -1.01459 +27 1 2.62716 1.70715 0.839166 0.688023 2.33788 1.05919 +28 1 1.6905 2.59418 0.903739 1.58905 0.257971 0.508129 +29 1 3.57454 1.77719 8.88663 0.186742 -0.0628404 0.80372 +30 1 4.38099 2.63699 8.92556 0.253897 0.0578989 -0.178058 +31 1 4.45919 1.78484 0.892793 0.372262 0.580252 -1.28381 +32 1 3.55804 2.657 0.821946 0.208194 0.440929 1.42052 +33 1 5.39579 1.85576 0.0513097 -2.11231 -0.770148 -0.833202 +34 1 6.28486 2.68552 0.0861957 -0.390024 -0.099671 -1.25573 +35 1 6.16167 1.79587 0.852166 3.13123 -0.282736 3.8241 +36 1 5.43841 2.67896 0.926914 -0.906522 -0.132525 -0.585389 +37 1 7.09214 1.72405 8.83985 3.26876 6.20695 4.03515 +38 1 7.96694 2.76043 0.0935037 2.29966 -0.680397 -1.28039 +39 1 8.06525 1.69772 0.940378 0.498274 0.445905 0.0355574 +40 1 7.16698 2.58338 0.88179 -1.8895 -0.0707859 1.12114 +41 1 0.0210451 3.48041 0.0428158 0.862491 -0.329006 -0.681709 +42 1 0.874431 4.40275 0.0131769 0.218928 -0.148848 0.324321 +43 1 0.851364 3.60752 0.914082 0.352487 -0.527665 -0.410754 +44 1 0.0749717 4.51844 0.974577 -0.257295 -0.287753 -0.288054 +45 1 1.76248 3.58626 0.0539576 0.480316 -2.29368 -1.63127 +46 1 2.72367 4.4241 0.0474256 0.0272964 0.241712 -0.452415 +47 1 2.73289 3.61199 0.901343 -0.0645249 -1.94992 -0.502421 +48 1 1.8456 4.38069 0.843492 -0.349918 1.31176 2.27682 +49 1 3.50387 3.55674 0.0315796 1.56114 -0.0224047 0.116984 +50 1 4.49692 4.37908 0.0780585 -4.54206 0.213106 -5.58215 +51 1 4.46671 3.57478 0.880458 -0.334204 -0.938728 0.874478 +52 1 3.58815 4.43 0.950374 0.652985 -1.92511 -1.59862 +53 1 5.3866 3.58372 8.92789 -1.19711 -2.22155 0.617325 +54 1 6.17276 4.37217 8.86047 6.00842 1.34471 4.78274 +55 1 6.27432 3.53871 0.907449 -0.148389 -0.137473 -0.523414 +56 1 5.27909 4.47835 0.809401 8.23917 -3.14067 4.34956 +57 1 7.09737 3.53698 8.87413 0.14026 -0.233191 0.941929 +58 1 7.96586 4.56922 8.84208 6.8748 -6.48505 1.75868 +59 1 8.1189 3.63425 0.96148 -3.00277 -1.46323 -4.15536 +60 1 7.14279 4.43222 0.962078 -0.0459577 0.247999 0.321752 +61 1 8.89637 5.43177 8.92691 0.327116 0.812268 0.0679643 +62 1 0.854018 6.30348 0.0813318 1.06274 -7.24911 -7.87042 +63 1 0.873415 5.41923 0.812761 -0.31071 -0.409433 0.423823 +64 1 8.88236 6.35419 0.863575 -0.753758 -3.06962 -0.690381 +65 1 1.76334 5.40934 8.88249 1.8326 1.29836 1.91996 +66 1 2.68777 6.21767 8.90577 0.0461489 1.51967 -0.262666 +67 1 2.66088 5.41906 0.821357 0.262109 -0.890774 -0.241847 +68 1 1.86017 6.31332 0.804602 -1.38053 -1.13952 0.850174 +69 1 3.64435 5.42051 8.90358 -2.6101 -2.17442 -0.370474 +70 1 4.37466 6.25131 8.85278 3.71832 2.70453 0.946098 +71 1 4.53047 5.2708 0.824393 -3.54051 3.8431 0.931364 +72 1 3.61222 6.27635 0.96909 -4.05414 0.604922 -3.58471 +73 1 5.40042 5.34751 8.8935 -0.719369 -0.36085 0.212296 +74 1 6.18215 6.3156 0.0196993 0.267387 0.110688 0.223648 +75 1 6.27516 5.37868 0.90209 -1.0642 -0.241069 0.481931 +76 1 5.31268 6.25584 0.875522 0.133781 0.115172 0.026661 +77 1 7.20113 5.30633 8.84474 -4.87308 6.78349 0.0391413 +78 1 7.95512 6.30497 0.092705 6.00614 -6.0265 -0.649957 +79 1 8.08767 5.35538 0.811364 -1.15126 0.392579 0.741715 +80 1 7.08607 6.1919 0.926051 0.630581 3.46407 -2.46157 +81 1 8.92405 7.0566 8.88782 -1.53371 0.564813 -0.0213323 +82 1 0.905011 8.13513 0.0600006 -0.504969 -0.194195 -0.00181653 +83 1 0.816253 7.07033 0.801556 1.36958 7.74762 7.34595 +84 1 8.83925 8.07727 0.907684 2.46931 1.67506 1.17354 +85 1 1.86043 7.09328 8.91972 -0.773441 0.857837 1.39948 +86 1 2.76541 7.99166 0.0440794 -0.77809 1.05822 0.425741 +87 1 2.67654 7.18636 0.91183 2.62219 -2.00002 -0.219028 +88 1 1.8788 7.9677 0.915621 -0.894934 2.07357 -1.21117 +89 1 3.59357 7.13026 0.0332195 -0.388167 0.00237965 -0.544686 +90 1 4.38663 8.07233 8.88382 0.174711 -0.440379 0.0897133 +91 1 4.5359 7.22854 0.936578 -2.37627 -1.04519 -2.35662 +92 1 3.63538 7.97981 0.824881 -1.61206 1.29888 2.0997 +93 1 5.3271 7.23059 8.92328 -0.111431 -0.20975 0.289951 +94 1 6.30867 8.05581 8.84577 0.0946421 0.0525728 2.57365 +95 1 6.32003 7.15576 0.891457 -0.2569 -0.483959 0.0547371 +96 1 5.40661 7.9868 0.968462 0.415884 0.0845497 -0.268424 +97 1 7.22798 7.08713 0.0563741 -5.45853 5.72078 -0.51002 +98 1 8.05735 8.06186 0.0753342 -0.611004 1.73052 -2.95918 +99 1 8.10922 7.21906 0.806609 -0.400473 -2.4357 2.42821 +100 1 7.16998 8.08498 0.846622 0.253892 0.388538 0.000271703 +101 1 8.88419 0.00785958 1.88382 0.148531 -0.55276 -3.06718 +102 1 0.806706 0.963107 1.6981 0.146821 -6.1479 7.24676 +103 1 0.81371 8.93107 2.59291 1.58623 0.25767 2.66866 +104 1 0.0914118 0.851308 2.7806 -2.96193 1.34432 -3.85013 +105 1 1.70908 0.055279 1.86232 -0.26684 0.0875329 -0.306957 +106 1 2.72497 0.940903 1.70203 -0.757536 -0.918748 1.71384 +107 1 2.71129 0.0639965 2.67102 -0.311468 0.261861 0.646041 +108 1 1.73889 0.96912 2.64369 0.123913 0.173982 0.666446 +109 1 3.52533 0.0194588 1.83263 1.01391 -0.00454228 -0.284845 +110 1 4.50633 0.992013 1.70842 -3.51938 -2.99082 2.23564 +111 1 4.49463 8.9275 2.60712 -6.23135 -0.421499 6.59704 +112 1 3.51061 0.932206 2.63613 0.265327 0.172351 0.555119 +113 1 5.26459 0.0845656 1.88118 6.41483 1.44516 -5.35427 +114 1 6.26822 0.943133 1.78953 -0.172034 -0.0988047 -0.238973 +115 1 6.20352 0.0931252 2.63772 -0.251863 0.451194 0.97073 +116 1 5.33497 0.961022 2.74861 1.85573 -2.10168 -0.655218 +117 1 7.15143 8.91799 1.69931 0.631991 0.791476 -0.168042 +118 1 8.1075 0.884637 1.85069 -0.145764 0.238097 -0.736312 +119 1 8.10277 0.00424992 2.71008 -1.61591 0.00687295 -1.36275 +120 1 7.06485 0.985537 2.76239 8.19773 -7.92397 -1.18231 +121 1 8.91698 1.83538 1.78872 0.656642 -0.0731624 0.0431027 +122 1 0.901335 2.58954 1.84197 -0.375827 -0.324571 -2.7055 +123 1 0.839546 1.79651 2.68072 1.09251 -0.901613 -0.242728 +124 1 0.0205195 2.75315 2.62687 -0.478759 -0.0106512 -0.67727 +125 1 1.78258 1.70562 1.69835 1.31189 0.545066 2.20675 +126 1 2.77409 2.6552 1.77928 -3.71202 0.456863 -3.25075 +127 1 2.62583 1.79361 2.77487 3.4762 0.328618 -3.48584 +128 1 1.71155 2.69761 2.62919 0.862289 -1.38539 2.38335 +129 1 3.5477 1.79572 1.86096 1.43061 -0.605958 -0.978191 +130 1 4.46749 2.5924 1.76238 -0.0494618 -0.0821277 -0.176353 +131 1 4.52929 1.74324 2.59829 -2.00749 0.662049 0.061349 +132 1 3.48188 2.69682 2.61959 1.88694 -0.141301 3.78311 +133 1 5.34711 1.71486 1.76809 1.96327 2.17405 -0.830705 +134 1 6.24637 2.73306 1.80484 3.10489 -2.12999 -0.788559 +135 1 6.31443 1.71423 2.71392 -8.21546 8.18972 -0.602972 +136 1 5.26572 2.69815 2.75971 0.0267628 0.10355 -0.216257 +137 1 7.18953 1.75159 1.71849 -0.576203 -0.36263 1.38792 +138 1 8.05027 2.77408 1.76451 0.439173 -0.587966 -0.341117 +139 1 8.01591 1.69661 2.74434 0.366947 0.0491547 0.134545 +140 1 7.14772 2.69371 2.58907 0.0738449 -1.92773 2.13155 +141 1 8.86781 3.66165 1.74517 3.90719 -1.47472 3.87657 +142 1 0.936621 4.42773 1.79512 -0.401045 -0.147867 0.321366 +143 1 0.948846 3.59531 2.72105 -0.571635 -0.0105131 -1.06193 +144 1 0.0834486 4.38982 2.63588 -0.524533 1.06652 0.75481 +145 1 1.83432 3.4799 1.75691 0.359017 0.665628 -0.818381 +146 1 2.69175 4.37077 1.75144 0.14004 0.214725 0.925417 +147 1 2.74153 3.6404 2.67912 -0.708299 -3.83642 -3.24565 +148 1 1.87968 4.54846 2.67269 -0.684796 -0.993828 -0.138535 +149 1 3.5441 3.51573 1.77434 0.186245 0.881611 -0.696526 +150 1 4.55171 4.52396 1.79145 -2.75839 -2.91024 -1.57263 +151 1 4.49896 3.65335 2.59498 -1.96388 -1.7196 0.869652 +152 1 3.49741 4.47737 2.77344 8.37692 1.8085 -7.7175 +153 1 5.44145 3.48872 1.74764 -3.05421 3.82286 1.14399 +154 1 6.1743 4.53053 1.74574 0.463366 -1.70291 0.122224 +155 1 6.30198 3.67131 2.70975 -1.07292 -0.185523 -2.51985 +156 1 5.34196 4.38653 2.7007 1.29125 2.52938 -0.102964 +157 1 7.1691 3.54339 1.87445 -0.749456 2.7751 -2.56091 +158 1 7.97266 4.40051 1.79603 0.56071 1.27489 1.72891 +159 1 7.99234 3.49992 2.67525 0.940044 2.40885 0.128516 +160 1 7.18063 4.50303 2.68825 -0.923025 -2.40154 0.0954191 +161 1 8.91159 5.33038 1.82507 -0.0203349 -0.241672 0.333237 +162 1 0.8958 6.32359 1.78851 0.38501 -0.14702 -0.347965 +163 1 0.943571 5.31749 2.71754 -0.318578 -0.34148 0.397124 +164 1 0.0864418 6.28418 2.68726 -1.86154 0.137969 -3.27119 +165 1 1.71465 5.37463 1.6949 -0.232891 -0.268012 0.301526 +166 1 2.72852 6.31988 1.88644 -2.78715 -2.37305 -5.95735 +167 1 2.64735 5.41101 2.73193 1.7471 0.192556 0.973026 +168 1 1.84919 6.27948 2.72157 -0.39498 0.808971 -0.0974847 +169 1 3.48336 5.2657 1.71665 0.625214 2.24561 1.33995 +170 1 4.39296 6.19435 1.72952 3.81534 -0.586193 2.86006 +171 1 4.52517 5.37564 2.62027 -1.99502 -0.45422 2.59567 +172 1 3.56333 6.24537 2.5877 2.83084 0.938216 3.4987 +173 1 5.32581 5.29562 1.86847 5.13697 3.80601 -2.04537 +174 1 6.24758 6.22298 1.79203 0.477004 0.378689 0.56244 +175 1 6.25283 5.44934 2.73731 1.14422 -0.830366 -0.337224 +176 1 5.45416 6.25624 2.6996 -2.42774 -1.74418 -0.22606 +177 1 7.22676 5.41803 1.71412 0.223451 -2.28899 2.0191 +178 1 8.0979 6.3518 1.78861 -0.44204 -0.435572 -0.338725 +179 1 8.01325 5.26918 2.64973 1.18264 0.878361 -0.124926 +180 1 7.11991 6.34415 2.69936 -1.3293 -2.66755 2.78128 +181 1 0.0635545 7.11209 1.72165 -0.371894 2.049 0.790012 +182 1 0.857409 8.07873 1.82753 -0.608672 -0.60495 -0.46291 +183 1 0.930573 7.24697 2.65225 -4.55248 -4.69883 0.513873 +184 1 8.8491 7.95414 2.58819 0.570786 1.09764 -0.00497061 +185 1 1.71811 7.19809 1.77835 0.893245 -0.692356 0.118249 +186 1 2.78024 8.04523 1.70672 -2.88976 2.48107 0.040135 +187 1 2.67012 7.13476 2.61708 -1.16009 2.6938 3.43626 +188 1 1.72659 7.99584 2.64342 2.19305 3.0992 -0.0129086 +189 1 3.48631 7.23394 1.84989 5.35093 -4.92393 -2.00054 +190 1 4.4261 8.04744 1.77118 -0.338387 -0.0128497 0.448007 +191 1 4.41287 7.13619 2.73708 2.81119 1.17101 -3.79683 +192 1 3.52255 7.96143 2.73527 1.04353 0.896155 0.0445218 +193 1 5.31509 7.09458 1.73703 1.75862 -0.357986 2.37379 +194 1 6.31592 8.04277 1.87992 0.07968 -0.344084 0.021952 +195 1 6.19476 7.08883 2.7194 5.13464 2.37882 -2.53303 +196 1 5.31616 7.97076 2.64032 0.139732 0.0575338 -0.0995313 +197 1 7.13779 7.0901 1.87785 -0.856279 1.84142 -1.45962 +198 1 8.00182 8.12007 1.73344 0.812689 0.333431 -0.248462 +199 1 8.01591 7.08327 2.73264 -0.0756439 0.769292 0.331432 +200 1 7.15074 8.00152 2.76416 1.82643 0.942676 -3.56152 +201 1 8.89655 8.9304 3.48678 1.65951 -0.447815 3.8493 +202 1 0.950495 0.819015 3.5162 -1.29532 1.69106 1.16913 +203 1 0.81801 0.0539921 4.51501 3.2278 -0.258036 -5.15445 +204 1 8.85177 0.90744 4.37372 14 -2.90794 10.8129 +205 1 1.78019 0.0426842 3.56938 1.84169 -0.836001 -0.350651 +206 1 2.63146 0.926366 3.57031 0.012479 0.082004 0.331715 +207 1 2.70742 0.0633514 4.41591 -1.37547 -1.33331 0.456319 +208 1 1.7142 0.801654 4.43761 0.662356 1.10176 0.272549 +209 1 3.65397 8.84382 3.54877 -3.56671 5.39916 0.463391 +210 1 4.3911 0.894602 3.52171 0.595814 -0.346452 0.321605 +211 1 4.50401 0.046887 4.49909 -1.14502 -0.949582 -0.274225 +212 1 3.51809 0.843433 4.41351 1.90854 2.37085 -0.229306 +213 1 5.34066 0.0102546 3.52427 -0.108558 0.828678 0.2339 +214 1 6.2908 0.991162 3.59141 -5.23018 -9.53106 -1.9323 +215 1 6.23033 0.0280237 4.46344 1.30838 0.516693 -1.50043 +216 1 5.29132 0.919899 4.38256 0.973507 -2.91573 1.14051 +217 1 7.06389 8.92307 3.63529 1.41369 0.894395 -0.0234904 +218 1 8.13244 0.926287 3.63848 -11.0259 -0.689673 -11.6462 +219 1 8.07431 0.0396355 4.42295 -0.0998371 -0.343464 -0.2111 +220 1 7.15426 0.902415 4.51611 0.37609 -0.87238 -0.174942 +221 1 0.0547819 1.70767 3.52402 -0.0990054 0.634623 1.9504 +222 1 0.990251 2.59589 3.64321 -1.70133 -1.15531 -1.34459 +223 1 0.876254 1.75025 4.46545 0.108846 -0.46015 0.445192 +224 1 8.851 2.6248 4.52232 3.89545 -0.330965 -5.02573 +225 1 1.83233 1.81735 3.53725 -2.40083 -0.602726 2.24699 +226 1 2.73685 2.66072 3.63237 -1.34367 -0.0545412 -0.555358 +227 1 2.76889 1.75912 4.53924 -5.46261 0.887424 -6.31803 +228 1 1.79935 2.60963 4.48075 0.43952 -0.293553 0.768966 +229 1 3.51296 1.81737 3.56522 0.159577 -1.35984 0.863711 +230 1 4.48313 2.73941 3.65804 -0.990489 -8.98093 -5.87222 +231 1 4.37894 1.70897 4.40451 -1.1595 -0.0369555 -0.272198 +232 1 3.5578 2.69572 4.44594 -0.0317478 -0.740538 0.514717 +233 1 5.41644 1.73157 3.63972 -0.214907 2.94643 -2.78853 +234 1 6.22995 2.60145 3.56616 -0.0106554 -0.60109 0.383738 +235 1 6.30303 1.6885 4.42264 -3.32083 3.037 6.44969 +236 1 5.43404 2.73282 4.52181 -0.69148 0.715375 -0.475461 +237 1 7.08666 1.7162 3.65955 7.29974 4.17951 -2.48105 +238 1 8.0318 2.68816 3.49666 -0.181832 0.425298 0.461358 +239 1 8.08432 1.70749 4.5149 -2.31295 1.75558 0.820722 +240 1 7.18431 2.71452 4.51289 0.136997 -0.067144 0.521486 +241 1 8.84691 3.61245 3.64188 4.42683 -0.879675 -3.24184 +242 1 0.916797 4.43325 3.62545 -0.842258 -0.010797 0.0107287 +243 1 0.871748 3.60004 4.51194 -0.301498 0.107107 -0.324598 +244 1 8.92426 4.51452 4.44006 -0.00859866 -1.77564 -0.547037 +245 1 1.68965 3.48331 3.5995 1.50205 1.26015 1.14935 +246 1 2.74619 4.38356 3.49878 -7.16717 1.90489 10.07 +247 1 2.74519 3.65012 4.52097 -2.02388 -3.55766 -1.13857 +248 1 1.75432 4.38414 4.53252 -0.421779 0.409337 0.409015 +249 1 3.58997 3.49254 3.52387 -0.821723 1.10659 0.0739307 +250 1 4.40569 4.52296 3.53187 0.545495 -0.966363 -0.0502063 +251 1 4.38156 3.4874 4.39271 -0.289264 8.2647 7.79533 +252 1 3.54333 4.42257 4.55563 2.80723 11.1106 -9.83606 +253 1 5.27331 3.5295 3.65482 2.61308 2.66186 -0.969787 +254 1 6.16108 4.46828 3.59956 0.599894 -1.41883 -0.240371 +255 1 6.22639 3.63251 4.44985 -0.305031 -0.480252 0.0742084 +256 1 5.31568 4.40222 4.46767 -0.344747 -0.443719 0.00587924 +257 1 7.10015 3.56367 3.49443 2.55034 0.169304 1.35525 +258 1 8.02171 4.37546 3.5697 -1.76106 3.37709 -2.28074 +259 1 8.069 3.64942 4.40708 -2.31714 -3.33053 6.18677 +260 1 7.18438 4.37135 4.52245 -1.79563 0.274401 -0.392524 +261 1 0.0758128 5.3487 3.5652 0.184463 -0.360483 0.192319 +262 1 0.795174 6.30898 3.53894 9.14413 -6.75396 2.48214 +263 1 0.867482 5.30202 4.453 0.791187 0.0370161 0.388706 +264 1 0.00225224 6.31064 4.52093 0.402626 -0.0990512 0.0415993 +265 1 1.75224 5.26394 3.64332 0.696547 0.221295 -0.114908 +266 1 2.74065 6.24856 3.64631 -0.500385 1.40459 -1.64071 +267 1 2.73855 5.4528 4.44688 -5.40773 -5.67129 2.9343 +268 1 1.74472 6.17623 4.53641 0.82995 0.717951 -0.0718944 +269 1 3.48421 5.34442 3.61728 1.66736 -1.06074 -1.09811 +270 1 4.41383 6.35055 3.60638 9.51906 -9.2799 1.43724 +271 1 4.38632 5.26464 4.48258 -0.919101 0.504742 0.900072 +272 1 3.55793 6.1617 4.49469 4.34711 2.82736 -0.340092 +273 1 5.36863 5.28325 3.49178 -0.734818 0.617922 -0.744768 +274 1 6.26503 6.19943 3.66319 0.429882 1.55809 -2.03015 +275 1 6.35487 5.3413 4.44757 0.561767 -0.978785 -0.133344 +276 1 5.27408 6.24166 4.56754 6.98603 1.54355 -5.42942 +277 1 7.19701 5.44828 3.47564 -5.73363 -4.54905 0.0826653 +278 1 7.95668 6.19688 3.55501 6.31824 5.03885 -1.22951 +279 1 8.09251 5.32103 4.3972 -0.525971 0.388914 -0.470954 +280 1 7.21521 6.34275 4.38759 -5.30552 -2.8442 0.851377 +281 1 0.0775826 7.08234 3.53581 -5.46769 7.72822 0.0708503 +282 1 0.933572 7.95134 3.59844 -0.0755868 -0.81045 -0.0294233 +283 1 0.967321 7.07254 4.42487 -1.68738 -0.0136546 1.81969 +284 1 8.87247 7.95576 4.3937 0.743652 0.272325 -0.92866 +285 1 1.76917 7.11669 3.64005 0.930468 -0.723585 -1.50003 +286 1 2.76456 8.10499 3.62233 -0.317456 0.121935 0.766743 +287 1 2.61456 7.10311 4.56718 0.759736 -0.536182 -1.28605 +288 1 1.85332 7.96709 4.49102 -0.903085 0.0612931 0.171005 +289 1 3.6668 7.06536 3.52857 -12.7314 9.15268 1.72289 +290 1 4.37522 8.04334 3.61636 3.8155 -4.43194 -0.0509001 +291 1 4.53661 7.19684 4.42303 -0.089737 0.0836956 0.326132 +292 1 3.62847 8.06443 4.56174 -6.53673 1.14979 -7.53287 +293 1 5.44626 7.09379 3.53396 -2.70855 0.0837127 2.61511 +294 1 6.30058 8.08668 3.48692 -3.50797 -0.210369 1.40313 +295 1 6.24642 7.05504 4.56658 1.23504 0.486666 -1.51311 +296 1 5.40389 8.14153 4.41484 -1.1149 -1.90428 -2.07503 +297 1 7.0793 7.23572 3.56625 0.390898 -5.13728 0.366365 +298 1 8.02564 8.11993 3.55841 -0.989908 -0.0289504 0.0817166 +299 1 7.96341 7.11444 4.5691 3.18586 3.20848 -0.902141 +300 1 7.14662 7.9965 4.39373 -0.0363915 0.663241 1.28885 +301 1 0.0665117 0.0620058 5.29566 -4.76408 0.0634028 3.8487 +302 1 0.920378 0.847838 5.33345 0.704711 1.73157 1.07432 +303 1 0.90733 0.0507073 6.29492 -0.256865 0.383558 -0.568888 +304 1 0.0695806 0.935871 6.21245 0.520609 -0.18085 0.460935 +305 1 1.7158 8.90069 5.2688 0.480844 0.845699 -0.0820744 +306 1 2.72956 0.862321 5.35582 -0.666933 0.680843 -0.243728 +307 1 2.75788 8.89573 6.26927 0.729554 0.867268 -0.717865 +308 1 1.87787 0.918127 6.17945 -0.463015 -0.230718 0.375845 +309 1 3.57292 0.0827463 5.28099 -0.282881 -3.17985 0.660183 +310 1 4.39889 0.831174 5.46088 -0.653335 9.17872 -7.1909 +311 1 4.53367 0.077487 6.1821 0.157227 -8.03625 7.38236 +312 1 3.56635 0.935389 6.31146 0.221361 0.0036999 -1.2625 +313 1 5.44773 8.84526 5.27719 -1.51548 1.46139 3.00719 +314 1 6.272 0.802404 5.33609 -0.667532 1.91594 -0.251293 +315 1 6.22537 8.89219 6.16591 -0.245349 -0.895062 1.43446 +316 1 5.33827 0.94153 6.32303 -1.13614 0.583964 -0.338203 +317 1 7.11863 0.0577427 5.44516 0.0248025 -1.55594 -0.512164 +318 1 7.97781 0.796351 5.39903 0.844611 2.54625 -2.84321 +319 1 8.06017 8.92765 6.18069 -0.104306 -2.31947 1.77241 +320 1 7.18164 0.989783 6.31023 -0.163547 -0.192109 -0.79717 +321 1 0.0916103 1.88258 5.39516 -1.00186 -1.43206 -0.661702 +322 1 0.982314 2.60245 5.42151 0.964023 2.57135 -1.73713 +323 1 0.897632 1.84422 6.25233 0.598171 -0.657266 0.69786 +324 1 0.0925235 2.7239 6.16577 -1.60764 0.211114 1.61705 +325 1 1.82959 1.77578 5.39133 -0.293694 0.755656 -0.589776 +326 1 2.69272 2.74727 5.44011 1.7292 -2.84836 -1.30998 +327 1 2.6889 1.83234 6.17525 0.647659 -0.90616 0.231454 +328 1 1.77521 2.70825 6.28078 0.536701 -0.406727 0.0293567 +329 1 3.51954 1.69427 5.29216 6.69261 0.0739574 6.33581 +330 1 4.4097 2.73314 5.34432 0.344675 0.135757 -0.187596 +331 1 4.40444 1.82369 6.16689 4.836 -4.97823 0.364517 +332 1 3.67178 2.60038 6.25743 -5.49724 5.54416 -0.00203516 +333 1 5.35146 1.77827 5.39473 -0.235283 0.213892 0.835574 +334 1 6.28399 2.77802 5.42862 -0.340126 -0.250486 -0.411738 +335 1 6.23134 1.81375 6.22687 0.0223138 0.244736 0.523936 +336 1 5.32351 2.70513 6.28288 3.08354 -1.69468 -3.77436 +337 1 7.14617 1.80036 5.35567 0.0919136 -0.311209 -0.475968 +338 1 8.0974 2.70612 5.29285 -7.26474 -2.41437 5.10983 +339 1 8.1011 1.88391 6.31294 0.0553936 -2.83177 -2.84321 +340 1 7.18351 2.67214 6.17899 0.615225 -0.197791 1.28477 +341 1 8.87232 3.47935 5.28683 2.9021 4.26792 0.541835 +342 1 0.935261 4.37233 5.44726 0.629241 0.918492 -0.917538 +343 1 0.919878 3.52494 6.23281 0.869805 0.127506 1.01894 +344 1 0.00431382 4.37186 6.33532 0.0302966 1.00444 -0.578346 +345 1 1.87251 3.50381 5.42034 -2.4415 2.77086 0.0779929 +346 1 2.70362 4.48406 5.3041 -1.90814 0.882252 2.42793 +347 1 2.75055 3.50273 6.30756 -1.47013 1.25632 -0.795276 +348 1 1.84448 4.4497 6.22456 -0.665656 -0.501499 -0.145372 +349 1 3.61741 3.6732 5.27884 1.4909 -8.59965 8.97662 +350 1 4.55362 4.53069 5.43699 -1.55164 -1.28771 -1.47171 +351 1 4.52256 3.52483 6.1944 -1.86903 1.10409 1.578 +352 1 3.65361 4.51782 6.21866 -3.39722 -3.70857 0.481797 +353 1 5.32088 3.65892 5.41856 2.55855 -1.45769 -1.45685 +354 1 6.25422 4.4123 5.33119 0.406295 0.346858 0.292537 +355 1 6.15978 3.47786 6.34128 0.227911 3.77427 -2.75081 +356 1 5.33342 4.43001 6.30433 -0.582231 -0.0994195 -0.382533 +357 1 7.19473 3.56016 5.44441 -0.898652 0.294925 -2.64663 +358 1 7.98682 4.41046 5.33513 1.4916 0.0945815 1.20731 +359 1 7.97947 3.58929 6.2697 1.92008 -1.0462 0.640867 +360 1 7.19164 4.45465 6.22659 0.298273 0.832684 -0.26134 +361 1 8.91866 5.33922 5.43231 0.972904 -0.678404 -1.89043 +362 1 0.863832 6.24178 5.44793 2.40494 -1.34388 -3.01765 +363 1 0.840212 5.37684 6.26703 1.52144 -3.32025 -2.26664 +364 1 0.0375152 6.17563 6.19921 -3.52547 2.50803 1.96141 +365 1 1.71406 5.31325 5.33193 0.359992 -0.20317 1.05182 +366 1 2.70446 6.22369 5.28953 -1.67496 -0.128385 2.17513 +367 1 2.62094 5.31478 6.20919 0.620292 0.0770975 0.0647467 +368 1 1.78318 6.16446 6.20286 -0.707464 0.30734 -0.850222 +369 1 3.5001 5.34304 5.42111 1.18155 0.33408 -1.88423 +370 1 4.48409 6.21311 5.27474 -6.47906 -0.498054 6.10955 +371 1 4.40434 5.30746 6.24861 3.30032 4.47126 1.95885 +372 1 3.65651 6.23636 6.35732 0.258101 -0.821502 -0.539452 +373 1 5.37686 5.39062 5.45706 -0.495794 0.303868 0.87367 +374 1 6.27665 6.3275 5.44876 0.578726 -4.19567 -0.915026 +375 1 6.28987 5.34918 6.28481 -0.689441 0.646514 -0.025026 +376 1 5.38856 6.30438 6.29204 -0.62461 -0.174266 -0.144794 +377 1 7.10303 5.36134 5.39788 0.303084 -0.453051 0.575398 +378 1 7.97278 6.2689 5.34555 1.29349 -0.0892034 0.239307 +379 1 8.1123 5.2681 6.25774 -0.648694 -0.661016 0.761589 +380 1 7.23419 6.34793 6.22344 -1.98134 -0.75315 1.10815 +381 1 0.0530217 7.08624 5.43675 -2.76329 0.356415 -1.34254 +382 1 0.891502 8.07734 5.33574 -0.449954 -0.433341 -0.0145848 +383 1 0.859902 7.08778 6.21702 1.22817 0.316603 2.39974 +384 1 8.86723 7.96664 6.28254 0.557062 3.16551 -3.15026 +385 1 1.77928 7.05564 5.34292 -1.2854 -0.797113 0.726349 +386 1 2.74792 8.05162 5.34603 0.580474 -0.247926 -0.00393627 +387 1 2.61984 7.13654 6.2076 0.1179 0.00397349 -0.327299 +388 1 1.73531 7.99204 6.32624 -0.619957 1.84241 -1.57732 +389 1 3.59984 7.17613 5.43634 -0.452415 0.706682 -0.14784 +390 1 4.39821 8.05962 5.28157 7.32724 0.749963 7.12774 +391 1 4.53389 7.20586 6.21186 -1.71384 -1.49003 0.809357 +392 1 3.66572 8.09269 6.23368 0.381787 -1.59697 -1.53597 +393 1 5.43811 7.11751 5.40192 -5.5589 -0.00418968 -4.06356 +394 1 6.35445 7.96959 5.31467 -2.59984 2.44569 0.360222 +395 1 6.17375 7.13942 6.18142 5.31103 3.8936 7.8957 +396 1 5.29125 8.02549 6.29493 1.99742 1.43167 0.441829 +397 1 7.11664 7.15874 5.38774 1.63444 -2.12611 -0.430051 +398 1 8.12983 8.0005 5.26693 -0.350623 0.791023 2.07438 +399 1 8.11089 7.10521 6.29529 -1.02761 -0.414645 -0.639575 +400 1 7.1542 8.04467 6.33119 -0.716395 -2.97685 -2.97233 +401 1 0.0455321 0.0581059 7.13785 -2.59331 -3.08955 0.589456 +402 1 0.853998 0.797568 7.23372 2.25232 12.9399 -9.25923 +403 1 0.893883 0.0531987 7.95582 -0.265032 -9.78891 10.4341 +404 1 0.0979374 0.927475 8.08374 -1.27945 -0.625441 0.909779 +405 1 1.70883 0.0184568 7.15475 0.947479 -0.211015 -0.0644084 +406 1 2.65212 0.910749 7.07723 -0.301347 -0.213339 -0.337826 +407 1 2.6305 8.90469 8.0727 2.55272 1.71066 0.384582 +408 1 1.75018 0.91387 8.02574 -0.526684 -0.686186 -0.483147 +409 1 3.61403 8.84934 7.06612 1.02988 1.44024 1.76178 +410 1 4.42034 0.91943 7.17223 0.522178 -1.61468 -2.10925 +411 1 4.37056 0.0516865 8.14003 0.0263315 0.189467 -0.466418 +412 1 3.59 0.934896 8.00045 0.0371044 1.00787 1.05016 +413 1 5.2816 0.0108877 7.14004 0.0410715 -0.366939 -0.311788 +414 1 6.23624 0.898837 7.05965 1.021 0.941131 0.654753 +415 1 6.246 8.87468 8.06175 -0.280098 0.535663 -1.1759 +416 1 5.31648 0.815501 8.12607 -0.78801 0.243527 -0.599256 +417 1 7.10707 8.84874 7.08197 -0.468775 2.08644 1.86713 +418 1 8.05013 0.946529 7.22788 -1.5208 -0.582053 0.186559 +419 1 8.1301 8.84043 8.01457 0.052244 0.715074 -0.282442 +420 1 7.06838 0.987221 8.03414 10.0415 -13.6791 -1.19755 +421 1 8.86835 1.70934 7.22731 2.54892 2.22649 -0.22541 +422 1 0.866325 2.76414 7.15029 -0.0137847 -2.49225 -3.8584 +423 1 0.826708 1.83336 8.03111 1.70357 -1.53255 0.309164 +424 1 0.0511912 2.65175 8.02861 -1.53037 1.53618 -0.152554 +425 1 1.7237 1.71044 7.1133 -0.3904 -0.435435 -0.731182 +426 1 2.66636 2.72018 7.14295 0.547793 -0.274295 0.648117 +427 1 2.70105 1.80209 8.13576 -0.0852062 -0.133841 -0.000493208 +428 1 1.77492 2.76081 8.10399 0.564357 -0.308093 0.985398 +429 1 3.66205 1.87543 7.16799 0.15905 -2.5091 -2.55207 +430 1 4.55348 2.70177 7.05301 -5.50098 -2.53366 3.01389 +431 1 4.46818 1.71608 7.96441 0.32513 1.80226 3.00161 +432 1 3.56091 2.58808 8.02945 0.396266 1.95642 2.12785 +433 1 5.36149 1.84637 7.16969 0.516803 -0.0610583 -0.802699 +434 1 6.28291 2.77184 7.1854 -0.512674 -3.17359 2.22694 +435 1 6.3427 1.71551 7.9726 -15.2061 11.4078 1.6664 +436 1 5.45463 2.61593 8.09933 0.73198 1.12429 -0.810915 +437 1 7.14617 1.80598 7.24022 4.03182 0.503759 -4.81039 +438 1 8.07521 2.6756 7.07092 -0.336894 3.22322 3.478 +439 1 8.11875 1.8373 8.10797 -1.57974 -0.493075 -0.537868 +440 1 7.09714 2.63714 8.02739 -0.0173147 0.820696 1.90431 +441 1 8.85027 3.56499 7.15253 3.00565 -1.27064 -0.682205 +442 1 0.885235 4.38222 7.18774 -1.842 1.22146 -0.226395 +443 1 0.884771 3.48141 7.97536 -0.530218 4.3971 3.23625 +444 1 0.0419078 4.41462 8.04436 -0.806344 -0.262731 -0.956831 +445 1 1.73746 3.66699 7.09267 1.85773 -3.96877 -1.41987 +446 1 2.66489 4.55163 7.19564 0.399017 -1.47837 -0.325749 +447 1 2.68401 3.61278 8.06372 0.262338 -0.0680464 0.329915 +448 1 1.80878 4.38262 7.9551 -1.46544 1.49945 2.09645 +449 1 3.55441 3.63471 7.17184 -0.0924634 0.45212 0.606799 +450 1 4.40759 4.53436 7.23701 0.160045 0.252781 -1.03281 +451 1 4.47938 3.49218 8.04219 0.177099 0.0940276 0.00712601 +452 1 3.55379 4.48752 8.06012 -0.927856 0.341505 -0.0833457 +453 1 5.30335 3.52949 7.1279 2.00125 1.71282 0.0663191 +454 1 6.19233 4.44015 7.09395 -0.123778 -0.82645 0.684973 +455 1 6.31698 3.55227 8.05766 -1.80584 -0.932697 -1.1518 +456 1 5.41804 4.43351 8.09204 -4.30063 -0.218755 -3.96516 +457 1 7.232 3.50321 7.24512 -0.569054 0.129485 -1.05452 +458 1 8.04777 4.39134 7.10023 -0.415559 1.27013 1.1937 +459 1 8.09921 3.54644 7.99275 -0.904288 0.185761 1.62031 +460 1 7.15284 4.38151 8.0646 -0.281528 0.0795406 -1.17401 +461 1 8.85944 5.36104 7.19522 1.71386 -0.372777 -2.67299 +462 1 0.808445 6.15874 7.05432 0.343929 1.70028 2.25424 +463 1 0.99266 5.36055 8.05319 -1.96195 -0.361049 -1.35199 +464 1 8.9228 6.22111 8.03716 -0.328906 0.253391 -0.16959 +465 1 1.7511 5.27554 7.16317 -0.501838 -0.493478 -1.59379 +466 1 2.7323 6.31099 7.08452 0.463177 0.0720173 0.389338 +467 1 2.75106 5.38162 8.09911 0.530948 -0.923774 -0.761524 +468 1 1.80446 6.33727 8.00982 0.567564 -0.353842 0.999402 +469 1 3.53218 5.32026 7.15711 1.3552 1.44822 0.141569 +470 1 4.49512 6.19462 7.20137 -2.95094 2.57244 -4.09211 +471 1 4.4829 5.43783 8.04952 -1.75843 -3.70774 -0.194014 +472 1 3.65767 6.24252 7.97233 -2.18137 -0.334806 -0.189717 +473 1 5.35752 5.46295 7.14871 1.05371 -2.23541 -1.50951 +474 1 6.22804 6.29485 7.12141 -0.370188 0.264704 -0.149428 +475 1 6.34127 5.4593 8.01496 -0.759119 0.239406 -0.0100712 +476 1 5.27101 6.21963 7.98358 4.21356 3.70888 3.53999 +477 1 7.2413 5.39744 7.15422 0.63332 0.408861 0.0765336 +478 1 8.01209 6.33115 7.20214 1.04149 -1.50251 -0.643312 +479 1 8.11155 5.33363 8.02803 -2.08279 1.51127 0.153008 +480 1 7.20203 6.31049 8.06426 -0.105023 -0.935886 0.140492 +481 1 8.92362 7.24394 7.10015 0.0792153 -3.18157 4.09933 +482 1 0.865164 8.02092 7.22606 2.85769 1.65383 -2.61434 +483 1 0.86745 7.15339 8.01815 -0.578541 -0.380635 0.364655 +484 1 0.0284189 8.08161 7.95725 -0.890268 -0.349283 1.10066 +485 1 1.85656 7.22057 7.11535 0.397315 -1.70504 3.16253 +486 1 2.77375 7.96501 7.15423 0.0953595 0.0574297 -0.272157 +487 1 2.64437 7.22314 8.11966 1.48696 -0.179689 -2.12782 +488 1 1.85941 8.11413 7.96635 -2.35368 -2.50728 -0.754549 +489 1 3.67468 7.10829 7.12824 0.65987 0.70298 0.656082 +490 1 4.46621 7.99739 7.2078 2.25404 -0.456947 -2.59682 +491 1 4.48001 7.09955 8.01357 0.0334801 0.324585 -0.290932 +492 1 3.6378 8.02597 7.95299 -1.96867 -0.619231 2.20677 +493 1 5.31589 7.17259 7.15585 0.23145 -0.930936 -0.437425 +494 1 6.20936 8.03122 7.09513 -0.13604 -0.296447 0.152582 +495 1 6.17543 7.22187 8.09898 5.44884 -7.61495 -1.62058 +496 1 5.43883 7.98222 8.0181 -6.37262 6.00913 -1.00537 +497 1 7.14576 7.09705 7.14015 0.407174 1.49093 0.0363952 +498 1 8.02588 8.07609 7.1284 1.43118 -1.40285 -0.689018 +499 1 7.99317 7.15919 8.00286 1.19218 0.601266 0.682892 +500 1 7.2435 8.04597 7.97482 -1.89044 -0.246287 0.1524 +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +500 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 8.5498797333834844e+00 +0.0000000000000000e+00 8.5498797333834844e+00 +0.0000000000000000e+00 8.5498797333834844e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 0.0109462 8.52194 8.48789 1.60777 3.16074 4.93288 +2 1 0.770239 0.886587 0.0775241 5.1148 0.619933 -4.35337 +3 1 0.914855 8.54009 0.795212 -2.54709 2.40671 3.27622 +4 1 8.53949 0.79582 0.824294 -1.87361 -0.316163 2.22706 +5 1 1.68126 8.45058 8.49491 -0.796772 17.9401 13.8601 +6 1 2.49257 0.906431 0.000759221 8.8197 -0.476032 2.96817 +7 1 2.62932 0.0354753 0.888378 -4.43263 -0.45206 -5.76212 +8 1 1.71329 0.913566 0.778252 -3.74188 -4.37189 3.26227 +9 1 3.42175 0.0965993 8.49503 -4.75784 -8.08943 10.1901 +10 1 4.21271 0.889278 8.46971 8.07159 3.26979 7.09905 +11 1 4.30903 0.0721078 0.771319 -2.20196 2.16322 3.01896 +12 1 3.42332 0.912751 0.876126 -1.2014 -0.27869 -2.68959 +13 1 5.04057 8.48132 8.46735 12.114 4.06773 4.60111 +14 1 5.95626 0.830289 0.0884189 2.64036 5.56585 -7.9642 +15 1 5.95178 0.0392781 0.802073 0.496214 -5.11156 5.55524 +16 1 5.1151 0.919125 0.80056 -4.53937 -3.75487 2.57161 +17 1 6.8031 8.46299 8.54479 -1.12262 1.88258 -1.67969 +18 1 7.77702 0.837169 8.46101 -2.81144 0.601723 4.97774 +19 1 7.61766 0.0190488 0.807902 2.02145 -3.01975 -0.996798 +20 1 6.83813 0.841817 0.893784 2.20091 1.15146 -3.46095 +21 1 0.00483518 1.7748 8.45086 3.14001 0.0124508 7.14446 +22 1 0.925315 2.54775 8.47859 -2.14676 3.17757 1.68537 +23 1 0.946475 1.73152 0.932031 -7.90083 -3.0997 -5.49951 +24 1 0.0820864 2.59152 0.95052 -16.5003 -1.1863 -19.4267 +25 1 1.62363 1.68342 8.4651 1.8496 1.86303 2.33818 +26 1 2.56251 2.66233 0.0202936 -6.7309 -4.60627 -0.0436147 +27 1 2.47347 1.71611 0.900003 2.27232 1.93928 0.205074 +28 1 1.66562 2.5538 0.89239 8.29789 -0.0162708 -2.14995 +29 1 3.47808 1.70927 8.49067 -6.21947 -0.00998514 1.91211 +30 1 4.19294 2.51037 0.0787296 16.1199 8.28753 -17.6776 +31 1 4.29711 1.73051 0.787489 0.142042 -5.75402 7.11231 +32 1 3.43681 2.6439 0.75999 -11.309 -9.11906 21.9869 +33 1 5.20599 1.76704 0.0398807 -10.2389 -11.7619 -5.76949 +34 1 5.91436 2.52733 8.51501 10.4145 9.83206 -1.49498 +35 1 5.9033 1.67223 0.919622 10.1161 4.25667 -5.1777 +36 1 5.15205 2.55373 0.788133 -1.76953 2.31199 6.90362 +37 1 6.92232 1.70971 0.0701593 -2.50899 -1.62202 -0.822044 +38 1 7.5955 2.61765 0.0592135 2.55821 0.640647 0.0382532 +39 1 7.74881 1.7729 0.896218 -1.59166 -5.96851 -6.46077 +40 1 6.80231 2.56106 0.910949 5.84287 -4.44794 -4.99646 +41 1 0.028349 3.48236 8.49963 2.5025 -5.04288 3.39467 +42 1 0.836484 4.27887 0.0816773 0.760548 2.93196 -2.43461 +43 1 0.942186 3.3633 0.783926 -3.69777 5.09684 -0.0674025 +44 1 8.51583 4.33027 0.838505 2.60137 -0.826864 1.21094 +45 1 1.65067 3.4812 8.47243 0.730068 -2.57113 1.91442 +46 1 2.5668 4.2649 8.54781 -0.773361 3.29166 6.51609 +47 1 2.51515 3.35935 0.92744 0.397687 12.5391 -13.0985 +48 1 1.73465 4.30243 0.83421 -1.47193 -2.67124 0.923933 +49 1 3.37869 3.37397 0.0291446 3.12688 15.3224 -6.53558 +50 1 4.34738 4.34434 0.00829503 -5.52046 -6.93359 -2.07611 +51 1 4.32411 3.36572 0.836745 -2.16657 1.87946 3.00206 +52 1 3.33524 4.20214 0.9322 3.17725 3.34929 -6.83564 +53 1 5.08499 3.41929 0.036632 4.03928 -2.58738 -4.81317 +54 1 6.04127 4.33974 8.49644 -0.624803 -0.102814 0.982479 +55 1 6.01611 3.33685 0.909561 -5.08671 5.06768 -6.62403 +56 1 5.207 4.2377 0.760733 -1.32975 0.891019 3.81461 +57 1 6.81304 3.47817 0.0178755 -0.843928 -8.06693 -2.50137 +58 1 7.73203 4.2048 0.00740382 -1.99245 1.66716 -1.57857 +59 1 7.78831 3.44874 0.953497 -3.78613 -1.03229 -4.77194 +60 1 6.90781 4.17709 0.825008 -1.46363 4.64194 5.22986 +61 1 8.46845 5.09622 8.47404 12.6898 1.90364 12.9104 +62 1 0.797366 5.93181 8.52222 2.38416 2.33873 2.4531 +63 1 0.806155 5.19524 0.885366 4.86564 -4.44474 -2.27198 +64 1 0.0123025 5.95271 0.830227 -4.90982 1.72838 0.59014 +65 1 1.70825 5.09756 8.50872 2.27411 3.17124 11.7261 +66 1 2.57892 5.99612 8.47434 -1.64581 0.780097 1.78814 +67 1 2.53606 5.08073 0.912891 1.82428 2.12405 0.338003 +68 1 1.76245 6.06361 0.855052 -0.817516 -1.26047 -0.587481 +69 1 3.36815 5.1611 0.0892763 -1.75416 -1.94918 -4.15038 +70 1 4.34388 5.99478 8.53994 -9.12199 -5.82315 -0.643131 +71 1 4.22842 5.14974 0.779802 4.93843 -0.926739 3.98855 +72 1 3.45177 5.94376 0.905424 -5.40353 3.18508 -3.48186 +73 1 5.06545 5.13306 8.4631 8.02458 6.68819 3.23791 +74 1 5.91929 6.01015 8.53548 3.77131 -1.20656 -2.03594 +75 1 5.88805 5.11842 0.816496 5.73582 1.96394 -4.01157 +76 1 5.18785 6.02276 0.820364 -9.36617 -3.77225 -2.84856 +77 1 6.8933 5.1517 8.49766 -1.10898 -0.445881 0.788116 +78 1 7.73242 5.99103 8.48869 1.48322 -7.68495 9.10162 +79 1 7.66553 5.0457 0.7869 0.413505 3.32493 1.60624 +80 1 6.9298 5.9353 0.896867 -3.44217 0.759559 -1.89572 +81 1 0.0757853 6.76414 0.08264 -2.09776 5.63137 -2.35842 +82 1 0.929754 7.68563 0.0937614 -14.24 2.10473 -10.1605 +83 1 0.947372 6.93568 0.898093 -37.7638 -41.2899 -5.14895 +84 1 0.0463649 7.75037 0.902481 -0.259219 -2.38896 -3.08434 +85 1 1.64115 6.89463 8.52754 6.28385 -7.53573 1.49633 +86 1 2.53763 7.75472 8.45351 15.1175 -6.89071 16.4408 +87 1 2.60347 6.88355 0.853331 -4.53589 -3.86491 -4.69681 +88 1 1.61173 7.63221 0.905993 43.7793 33.7511 -1.13346 +89 1 3.3813 6.82692 8.54355 -0.238432 1.95456 2.34043 +90 1 4.24371 7.77989 0.043504 -5.67067 -7.72392 -1.84442 +91 1 4.1828 6.86814 0.818276 1.21815 -0.827933 0.630987 +92 1 3.3368 7.7382 0.923275 7.52639 -2.01137 -4.72269 +93 1 5.071 6.7563 0.010658 5.49209 11.6713 -3.15323 +94 1 5.90188 7.6356 0.0424163 1.86621 0.862931 -1.97936 +95 1 6.03172 6.8673 0.938495 -1.34369 1.09475 -9.39496 +96 1 5.15248 7.77523 0.857214 -2.90101 -1.73408 2.05686 +97 1 6.89959 6.76423 0.01648 -11.1028 0.34724 0.750719 +98 1 7.65506 7.70409 0.0429309 2.74021 -1.34663 -2.67212 +99 1 7.64597 6.8087 0.792436 6.14337 0.285334 5.54838 +100 1 6.81299 7.61529 0.784654 1.50923 3.73377 2.87701 +101 1 0.039157 8.46192 1.76149 -3.85041 1.88762 -2.12951 +102 1 0.799188 0.819633 1.69376 4.21763 0.723161 -3.63495 +103 1 0.763005 0.0408753 2.55669 11.5628 -1.30287 -1.53659 +104 1 0.0652633 0.934891 2.49039 -5.1145 -1.67274 5.33691 +105 1 1.66381 8.45402 1.66249 1.87623 5.22247 1.17986 +106 1 2.503 0.802578 1.65731 0.0918423 3.77669 3.70231 +107 1 2.51579 0.0135642 2.53917 0.463256 0.0266605 -0.815012 +108 1 1.65685 0.926197 2.57259 5.9178 -9.1905 -0.306187 +109 1 3.4242 0.0443963 1.67808 1.33331 -0.794171 2.32841 +110 1 4.23298 0.877511 1.6619 2.15651 0.36791 0.599305 +111 1 4.23114 8.48221 2.59613 0.139704 5.19667 3.26797 +112 1 3.42382 0.825355 2.52764 0.831325 -0.597344 0.750298 +113 1 5.10755 0.098598 1.64667 1.13835 -0.15217 0.418453 +114 1 6.07979 0.861483 1.66377 -9.38879 -3.1028 5.61252 +115 1 6.06362 0.0403691 2.64895 -6.98521 -8.98289 -11.9164 +116 1 5.20913 0.939312 2.59362 -1.28414 -1.16831 -2.67638 +117 1 6.75529 8.52816 1.79359 4.36806 -0.709446 -4.01445 +118 1 7.76101 0.764033 1.62558 -1.73868 3.93794 4.49945 +119 1 7.66206 0.0708021 2.53607 1.47505 -2.32899 1.29594 +120 1 6.92286 0.947435 2.52138 -4.88314 -16.5943 7.22153 +121 1 8.51449 1.72985 1.71942 6.76951 -3.05423 -0.995536 +122 1 0.834691 2.62553 1.61171 16.0236 -0.437826 23.4167 +123 1 0.945534 1.71145 2.53519 -17.6422 5.766 10.6769 +124 1 8.53575 2.60321 2.48391 2.61084 -9.58061 10.2444 +125 1 1.63294 1.72028 1.76938 14.1815 -0.440268 -11.5313 +126 1 2.57682 2.65502 1.67415 2.8611 -15.9615 10.724 +127 1 2.65189 1.65955 2.48962 -4.47742 1.085 2.58429 +128 1 1.79145 2.49644 2.55538 0.0425348 2.96537 1.56716 +129 1 3.45687 1.73281 1.73911 -3.75938 -0.279924 -8.91417 +130 1 4.34908 2.51749 1.7514 -3.12574 5.69408 -7.34516 +131 1 4.21985 1.73239 2.48294 4.56177 -5.44217 8.83153 +132 1 3.39941 2.5984 2.48766 0.0932155 -0.49927 3.02478 +133 1 5.22539 1.80308 1.7328 -5.21779 -2.43895 2.23844 +134 1 6.07426 2.60134 1.71356 -9.82102 -9.11759 6.53349 +135 1 6.06098 1.72463 2.48049 -24.0059 1.32147 25.9525 +136 1 5.04217 2.48583 2.60699 6.13261 3.37855 2.31458 +137 1 6.77443 1.68358 1.80416 26.2694 11.8834 -33.3324 +138 1 7.78345 2.52468 1.65191 -10.0717 7.23238 6.81167 +139 1 7.67217 1.70427 2.51662 7.38759 5.50979 0.483479 +140 1 6.87655 2.54802 2.65887 0.828003 6.30102 -11.6733 +141 1 8.48905 3.38009 1.79052 3.95862 11.358 -4.16794 +142 1 0.904648 4.31805 1.73458 -1.64595 0.0791848 -3.59387 +143 1 0.882159 3.48871 2.5578 -1.47386 -2.40831 0.515883 +144 1 0.0640856 4.36164 2.51005 -1.54232 -2.6948 -1.06039 +145 1 1.78366 3.38548 1.78248 -8.79706 -1.19951 -6.15917 +146 1 2.61647 4.18826 1.75601 -13.6767 13.2656 0.0962066 +147 1 2.49967 3.46972 2.59724 11.287 -7.88562 -0.187146 +148 1 1.72994 4.21494 2.4741 -1.76295 10.5241 6.69302 +149 1 3.35408 3.46945 1.74549 12.0923 -11.3982 2.63093 +150 1 4.33371 4.2573 1.65266 -1.0572 -0.0681575 -0.357999 +151 1 4.25135 3.37501 2.62082 -0.724851 2.23609 -3.08367 +152 1 3.37046 4.34755 2.6064 0.218455 -8.01846 -3.14612 +153 1 5.16664 3.3978 1.80383 -2.26051 -2.46633 -4.30603 +154 1 6.02075 4.21565 1.63908 -0.444656 2.88859 -0.464916 +155 1 6.04443 3.46025 2.46975 -2.50911 -3.21487 7.82311 +156 1 5.06457 4.21348 2.57808 1.01082 5.99339 -2.31274 +157 1 6.80721 3.3694 1.6818 12.0846 7.00158 1.77966 +158 1 7.66426 4.31037 1.75089 1.93845 -1.12426 -1.15071 +159 1 7.67666 3.35746 2.66226 0.0349977 1.35377 -1.51011 +160 1 6.86746 4.18845 2.58559 1.34212 2.76274 1.29577 +161 1 0.0121787 5.21746 1.67805 -1.66136 -3.05338 2.49187 +162 1 0.848043 6.06063 1.634 -1.152 -1.54074 2.03353 +163 1 0.891535 5.1714 2.53903 -1.80088 0.0367987 2.5043 +164 1 8.53141 6.02479 2.48115 1.46529 0.600203 2.28151 +165 1 1.67096 5.18637 1.75513 2.90335 -0.353263 -4.03581 +166 1 2.63344 6.0279 1.70432 -16.3644 -8.57778 -6.55322 +167 1 2.48532 5.10477 2.59913 0.462017 -0.718364 -1.79537 +168 1 1.74617 5.95248 2.59859 0.0442724 3.34654 -0.327538 +169 1 3.3871 5.11741 1.76498 -0.70902 0.100622 -1.55997 +170 1 4.23897 5.91622 1.65627 3.82091 1.24022 3.5679 +171 1 4.18272 5.19526 2.64844 4.07887 -0.154168 -2.99301 +172 1 3.33243 6.04257 2.48749 13.2178 -9.29314 8.76503 +173 1 5.21355 5.13048 1.6694 -5.38913 -0.724028 1.81762 +174 1 5.88731 6.04999 1.61164 27.08 -23.484 7.87668 +175 1 5.91685 5.19555 2.55373 8.22272 -5.32197 -1.91553 +176 1 5.22513 6.01752 2.48789 -6.37641 3.03262 4.81469 +177 1 6.87923 5.14396 1.75241 -1.31228 -0.52571 -0.175031 +178 1 7.66325 6.00346 1.75398 1.55065 0.721262 -1.56625 +179 1 7.71088 5.21107 2.64045 -0.197441 -3.63935 -3.47269 +180 1 6.81367 6.03163 2.50271 -0.887486 -5.65654 8.47366 +181 1 8.45469 6.86312 1.68381 5.32955 -1.93357 -1.0964 +182 1 0.887234 7.64699 1.70441 -8.03342 4.67955 6.65869 +183 1 0.827773 6.84361 2.49826 0.666014 -0.927683 2.41577 +184 1 0.0243326 7.6531 2.64337 -2.41729 -1.59288 -7.26092 +185 1 1.67566 6.82407 1.70759 6.3287 0.149047 4.42322 +186 1 2.51454 7.65687 1.63227 -3.24159 2.2536 7.24906 +187 1 2.61047 6.80534 2.59521 -8.48569 7.62473 -2.75927 +188 1 1.62469 7.75189 2.55083 1.70283 -3.32336 -0.400725 +189 1 3.32845 6.81114 1.68061 10.3844 9.25335 0.5217 +190 1 4.35781 7.7751 1.79868 -7.49989 -3.23754 -13.7369 +191 1 4.19243 6.92819 2.60428 15.2501 -13.591 -1.36339 +192 1 3.43706 7.60555 2.52571 -13.7857 14.6138 -0.968483 +193 1 5.20185 6.77695 1.66316 -21.9331 19.6829 3.32007 +194 1 5.90138 7.62608 1.77842 3.59956 5.50204 -2.20333 +195 1 5.95566 6.93899 2.64467 1.5684 -14.0837 -9.48217 +196 1 5.06902 7.62841 2.55428 6.74225 1.46675 8.63059 +197 1 6.76742 6.8085 1.78801 1.36869 6.36826 -6.59728 +198 1 7.65843 7.62584 1.68675 -2.22178 4.8322 -2.62428 +199 1 7.67415 6.89867 2.52463 2.21143 -5.15334 3.5596 +200 1 6.87662 7.66202 2.55284 -3.26152 2.73313 1.32325 +201 1 0.0405641 8.51038 3.32948 -5.92557 3.54592 8.59039 +202 1 0.809165 0.908392 3.38948 1.71953 -1.70344 0.923667 +203 1 0.901714 8.46653 4.19384 -9.71216 4.93867 8.34322 +204 1 0.069999 0.928448 4.31429 -4.27362 -2.53344 -6.14786 +205 1 1.6264 8.4509 3.42354 8.98155 6.03203 -6.76996 +206 1 2.65602 0.762944 3.43842 -5.54094 5.64927 -11.0802 +207 1 2.61793 0.0468587 4.22961 -1.55064 -6.54911 6.6458 +208 1 1.68094 0.888048 4.32275 0.711784 -4.72688 -3.71581 +209 1 3.43429 8.45723 3.40115 7.64008 12.4108 0.619842 +210 1 4.23416 0.880739 3.42582 5.39503 -6.32873 -0.402512 +211 1 4.18642 8.4609 4.33191 11.6244 16.7018 2.29066 +212 1 3.36155 0.898574 4.22656 4.93072 -1.64922 5.55995 +213 1 5.13206 0.0787666 3.45034 -0.945527 -3.11163 -2.8253 +214 1 6.05542 0.815095 3.33818 0.680768 11.3265 10.7561 +215 1 5.88615 0.068379 4.32153 11.9175 -9.57172 -8.45948 +216 1 5.21525 0.885851 4.19789 -5.15816 5.54694 4.34946 +217 1 6.80589 8.45257 3.40423 5.88256 0.0541198 6.21084 +218 1 7.74454 0.870555 3.46229 0.501904 -4.05279 -5.44709 +219 1 7.62711 0.0144156 4.35804 1.95636 -0.757148 -6.431 +220 1 6.7475 0.756319 4.34542 2.82117 3.60456 -0.442947 +221 1 0.046471 1.74765 3.48426 -2.94726 0.460616 -2.28233 +222 1 0.888532 2.54472 3.37968 0.966992 1.17998 0.546373 +223 1 0.832134 1.79852 4.28422 5.1168 -14.8036 -11.8055 +224 1 0.0855384 2.60849 4.37243 -9.37894 3.13224 -11.0091 +225 1 1.76053 1.64213 3.45381 -3.40447 2.71972 -2.85028 +226 1 2.52635 2.61582 3.43297 3.65437 -1.51294 -3.08517 +227 1 2.50122 1.75788 4.25552 8.72555 -0.689386 -1.86072 +228 1 1.75205 2.6278 4.21833 -8.89154 -5.54607 2.69229 +229 1 3.50205 1.65486 3.36684 -7.50491 6.39615 -0.836562 +230 1 4.28152 2.60594 3.4252 -1.76945 -2.76432 2.53661 +231 1 4.17705 1.67239 4.28707 6.76533 -1.25356 -1.29705 +232 1 3.44438 2.47178 4.25656 -4.81944 5.002 -0.576402 +233 1 5.22486 1.68937 3.43619 -3.28026 2.78772 -4.39101 +234 1 6.02069 2.55292 3.33778 -3.72236 0.507942 3.01424 +235 1 5.96152 1.77008 4.23889 4.98563 -0.248026 3.40967 +236 1 5.17107 2.61009 4.24734 -0.598251 0.473097 -0.376582 +237 1 6.87337 1.72985 3.32607 -2.78397 -6.76638 7.83701 +238 1 7.692 2.50127 3.44714 2.52098 2.71173 -0.194497 +239 1 7.63531 1.64894 4.19535 0.881487 3.19892 6.53537 +240 1 6.92924 2.5559 4.32195 -3.68781 1.74243 -2.92343 +241 1 0.0154582 3.42553 3.38818 0.573657 0.250438 1.11994 +242 1 0.946668 4.34133 3.49534 -14.1263 -16.7645 -9.90419 +243 1 0.911751 3.43019 4.31621 -0.850264 0.755291 -1.68921 +244 1 0.0046042 4.25775 4.34424 -1.31738 -1.24756 -1.54253 +245 1 1.76086 3.48229 3.3966 -12.418 -8.98763 3.21891 +246 1 2.48605 4.22978 3.40508 14.0841 10.3397 -4.15997 +247 1 2.54799 3.33831 4.30225 4.92033 13.8543 -7.00111 +248 1 1.7676 4.3622 4.17566 0.280546 -16.6448 26.3844 +249 1 3.37038 3.45998 3.42173 -0.200746 -1.45028 -1.29578 +250 1 4.20874 4.30541 3.50172 4.65367 -11.48 -19.1828 +251 1 4.21154 3.43635 4.23457 4.19917 -3.40534 2.03948 +252 1 3.45806 4.23712 4.25878 -8.55751 2.75292 6.08306 +253 1 5.11168 3.47839 3.3691 -0.311412 -5.69502 5.70804 +254 1 5.92148 4.26406 3.41002 5.13821 -1.04796 0.0327238 +255 1 6.02264 3.46008 4.23226 -3.02748 -3.55814 1.41554 +256 1 5.17114 4.24863 4.35423 -2.77791 4.93248 -13.0008 +257 1 6.86557 3.34851 3.50434 -4.54964 -0.0741147 -9.06001 +258 1 7.67607 4.29403 3.50495 4.02814 6.65377 -10.7943 +259 1 7.67432 3.49417 4.17544 8.6417 -11.3672 14.2425 +260 1 6.8466 4.22166 4.23144 -3.46256 4.46394 4.938 +261 1 0.0814499 5.05812 3.37338 -2.94602 3.43381 2.0972 +262 1 0.952662 5.9924 3.43554 -2.60446 0.4469 0.54362 +263 1 0.765082 5.07607 4.26673 5.31334 4.0071 5.5605 +264 1 0.0672914 5.95184 4.29838 -1.77164 3.23629 -2.96482 +265 1 1.64676 5.09677 3.49021 9.45599 25.7387 -15.7709 +266 1 2.59524 6.06011 3.441 -1.69946 -11.0916 -4.14222 +267 1 2.46878 5.21999 4.3176 5.41184 -22.6386 -22.4739 +268 1 1.72435 5.99765 4.33067 -8.961 3.18884 -2.81076 +269 1 3.33576 5.13502 3.32819 -1.95672 4.97188 10.3591 +270 1 4.33219 6.01601 3.4905 -3.43576 -1.4684 -1.43775 +271 1 4.2868 5.05318 4.19611 2.54498 12.874 12.0539 +272 1 3.47487 5.92769 4.31716 -1.095 0.823289 -0.856965 +273 1 5.22135 5.10776 3.40172 -8.93936 2.06172 1.30023 +274 1 6.0405 5.92456 3.43523 0.724841 2.24513 0.144002 +275 1 5.92006 5.1314 4.26005 8.25611 -3.42587 -2.20917 +276 1 5.11155 5.91401 4.29084 1.00396 1.28478 -0.181662 +277 1 6.86476 5.07118 3.47111 -5.70253 1.83988 -3.65428 +278 1 7.60709 5.97166 3.43329 1.57958 3.02153 1.22094 +279 1 7.62121 5.17116 4.25108 13.415 -9.76593 -1.32536 +280 1 6.90725 5.93696 4.35438 -12.0061 10.5099 -5.89092 +281 1 0.0158532 6.88433 3.5005 2.50125 -3.66413 -3.15884 +282 1 0.832759 7.6858 3.39159 0.810583 -3.83454 1.16734 +283 1 0.879361 6.87893 4.25184 1.06811 -4.80567 -3.71366 +284 1 8.48025 7.67569 4.32838 6.71448 4.3067 1.89144 +285 1 1.76699 6.83608 3.37875 -3.92913 2.06189 -0.762911 +286 1 2.64337 7.79272 3.38564 -11.5742 -11.6301 0.504133 +287 1 2.51611 6.79594 4.20547 2.9771 6.7763 8.40555 +288 1 1.73472 7.75634 4.30153 3.5376 -4.65751 1.06495 +289 1 3.42458 6.78486 3.36363 0.711862 2.92454 6.30952 +290 1 4.29146 7.78029 3.51531 3.92856 -8.43358 -6.61451 +291 1 4.22796 6.89496 4.356 2.49253 -3.58746 -4.19183 +292 1 3.49073 7.69895 4.31251 -15.4332 -7.21194 0.0843114 +293 1 5.03295 6.88949 3.43613 2.4132 0.715094 1.20127 +294 1 5.9914 7.60738 3.43115 0.166605 10.2994 10.8333 +295 1 6.06057 6.76316 4.28526 -0.682389 0.774521 0.518315 +296 1 5.1506 7.68481 4.35956 -0.587179 -0.831286 -4.17718 +297 1 6.91829 6.87557 3.41173 -2.20287 0.087574 0.74732 +298 1 7.77376 7.66664 3.47631 -5.20912 2.94829 -3.10686 +299 1 7.7733 6.85147 4.2793 -6.28798 -5.26886 2.97867 +300 1 6.79627 7.70864 4.34123 1.13479 0.471756 -2.41754 +301 1 8.47537 0.0666715 5.07785 3.07732 -2.35936 2.36099 +302 1 0.837862 0.824189 5.08442 2.67015 -0.0526079 4.2528 +303 1 0.947354 8.53746 5.97515 -9.44477 -2.06512 3.38353 +304 1 8.45527 0.903487 5.90211 4.35699 -8.49334 13.6006 +305 1 1.71466 0.0614796 5.21675 1.71751 -10.7388 -14.8483 +306 1 2.56545 0.785351 5.1483 1.0332 2.19745 -1.75997 +307 1 2.58448 8.48208 5.91956 0.430753 0.76971 3.58164 +308 1 1.65003 0.816215 5.93197 3.03102 12.7849 8.36083 +309 1 3.46033 0.0141985 5.16494 -4.25366 -0.783326 -0.484155 +310 1 4.20213 0.929517 5.13838 2.42665 -3.78185 -0.152962 +311 1 4.26733 0.0836521 5.92638 3.25998 -1.091 1.74874 +312 1 3.41102 0.861262 6.03148 -0.949591 0.0559607 -1.66554 +313 1 5.1564 8.53616 5.06672 -11.5945 -0.673098 9.37255 +314 1 5.94115 0.761043 5.20173 4.62182 33.122 -29.3364 +315 1 5.93463 0.0696556 5.8868 1.75697 -30.8547 30.3151 +316 1 5.14065 0.9256 5.95741 -0.006185 -4.789 2.4932 +317 1 6.91953 8.50208 5.18386 -10.6338 4.52372 2.129 +318 1 7.72317 0.898909 5.10883 -6.55365 -0.206627 -4.30053 +319 1 7.67728 0.0288812 5.99182 2.50541 0.776267 0.642418 +320 1 6.91834 0.891409 5.91811 -4.13582 -0.84176 -0.41985 +321 1 0.0355634 1.62397 5.15959 0.786537 13.0999 -7.10363 +322 1 0.855042 2.4658 5.05819 10.8208 10.8619 21.426 +323 1 0.798893 1.71459 6.01685 5.79471 -4.43182 -0.915803 +324 1 0.0659206 2.49237 5.91102 -5.57064 6.4328 0.916789 +325 1 1.77633 1.69788 5.04117 -5.55508 3.43302 7.46453 +326 1 2.55086 2.64298 5.08873 0.0193134 -8.77259 6.85672 +327 1 2.49765 1.63315 5.92814 1.12021 1.50275 1.88199 +328 1 1.80539 2.621 5.95731 -6.21714 -3.35524 -0.269961 +329 1 3.34329 1.63256 5.07699 -2.20219 4.06192 2.43743 +330 1 4.31458 2.52073 5.06335 -0.0632538 1.3392 1.20942 +331 1 4.33916 1.68863 5.97126 -3.41941 3.44417 2.01134 +332 1 3.42212 2.64548 5.89276 -0.0280586 -2.67425 3.44656 +333 1 5.16333 1.72803 5.18363 0.62931 0.268233 -3.53629 +334 1 5.97493 2.53755 5.18126 5.42417 -2.99996 -10.5798 +335 1 5.97644 1.77632 6.05208 2.30795 -0.932212 -2.38345 +336 1 5.20771 2.64035 5.9206 -9.19429 -1.91265 5.67918 +337 1 6.82113 1.7288 5.07227 0.319047 -2.27809 2.42075 +338 1 7.76584 2.66005 5.04767 0.36372 -2.98667 3.98468 +339 1 7.68048 1.73285 5.98682 1.83082 2.55026 -3.35109 +340 1 6.77723 2.66049 6.0628 11.9195 -28.0419 -0.192401 +341 1 8.52926 3.48894 5.20725 0.756027 -4.20422 -2.12394 +342 1 0.880496 4.18659 5.21886 -2.21024 5.88812 -5.98946 +343 1 0.823278 3.46696 6.03218 3.03891 -2.5906 1.31712 +344 1 8.45604 4.28238 5.97679 3.43734 -0.298701 2.3281 +345 1 1.66848 3.43018 5.1681 4.45896 -2.65722 -0.776378 +346 1 2.47623 4.29797 5.21376 10.0204 -9.1421 -8.64412 +347 1 2.46945 3.49538 6.0664 15.3766 -12.245 -4.5397 +348 1 1.75883 4.22715 6.00615 -17.7933 12.7993 4.23364 +349 1 3.32535 3.48763 5.18919 1.16348 3.11251 -2.54898 +350 1 4.29953 4.30461 5.21296 -7.48003 6.57243 -13.8987 +351 1 4.32836 3.50006 5.90127 -9.25916 -18.9556 4.88449 +352 1 3.45987 4.23872 6.06433 -4.26661 1.09432 -3.11516 +353 1 5.16317 3.46797 5.05136 -2.20358 -10.3645 8.38524 +354 1 6.01128 4.18674 5.11415 3.72823 2.851 1.21774 +355 1 6.05124 3.32995 5.89897 -17.0823 24.7049 3.10753 +356 1 5.05098 4.23901 5.94533 18.4684 10.5132 6.34816 +357 1 6.93195 3.37363 5.21832 -12.1973 3.61502 -16.8233 +358 1 7.67472 4.24466 5.1448 -0.046387 1.44369 -2.14451 +359 1 7.59877 3.3598 5.99617 16.3705 11.4653 3.48987 +360 1 6.9163 4.33093 6.01136 -0.884888 -0.827495 0.436994 +361 1 8.47485 5.1618 5.06757 4.58611 -6.95556 3.64111 +362 1 0.866551 5.92561 5.22826 -2.4458 0.731452 -4.83922 +363 1 0.856029 5.03088 5.93872 -0.961264 1.16585 2.50638 +364 1 0.025531 6.08363 6.03301 -0.603503 -3.86392 0.433571 +365 1 1.73882 5.05771 5.16436 -7.87894 6.49017 -0.085231 +366 1 2.54586 5.89415 5.04217 4.79689 21.4637 24.3945 +367 1 2.63875 5.11717 5.9033 -10.4096 0.222879 12.4433 +368 1 1.7282 6.02787 5.89482 3.82714 -3.17245 6.07309 +369 1 3.41343 5.11888 5.19776 7.89672 -3.25441 -9.4893 +370 1 4.34849 6.08405 5.13729 -6.43313 -7.37614 1.57014 +371 1 4.30919 5.18003 6.06007 -0.523489 -1.53897 -0.492658 +372 1 3.32135 5.97978 5.88753 6.80953 0.93257 3.29984 +373 1 5.2281 5.04347 5.09516 -5.81719 1.07839 6.76004 +374 1 5.94602 5.8851 5.09539 3.02249 4.44225 2.10278 +375 1 6.04092 5.17575 6.07061 0.50428 -9.39491 -12.3653 +376 1 5.21437 6.06631 6.06016 -6.35945 -8.11006 -13.4627 +377 1 6.91579 5.12007 5.08308 -5.11836 -4.49572 6.409 +378 1 7.70983 5.91053 5.07808 1.5309 9.32926 6.58643 +379 1 7.76683 5.15653 6.01534 -1.66429 -5.18049 -8.59085 +380 1 6.93784 6.03915 5.96221 -25.2768 -19.3137 -6.75792 +381 1 0.0625638 6.74931 5.10819 -0.676634 2.54846 -0.0250987 +382 1 0.86361 7.61298 5.03345 -2.5044 7.0388 6.38474 +383 1 0.851706 6.88156 6.03092 0.201379 -3.97494 -1.33706 +384 1 0.0506067 7.6425 5.89338 -1.769 2.22377 0.622415 +385 1 1.66322 6.86583 5.19561 3.09287 -3.33398 -7.05581 +386 1 2.62799 7.62451 5.17609 -27.9662 28.0267 -4.59006 +387 1 2.66202 6.83135 5.96842 -24.8289 -0.817724 19.495 +388 1 1.64735 7.66733 5.92394 4.49398 5.54382 1.70924 +389 1 3.32274 6.93842 5.22499 45.6897 -26.2601 -20.0997 +390 1 4.28266 7.68312 5.1494 -0.162983 0.307259 3.3477 +391 1 4.21122 6.74188 6.04596 -0.795282 5.66715 -3.63702 +392 1 3.40786 7.67271 6.05784 2.18013 1.35082 -0.335047 +393 1 5.13386 6.80127 5.05013 6.80473 4.27889 3.23937 +394 1 6.0188 7.62146 5.18796 -3.27693 10.2601 -11.1928 +395 1 5.9142 6.93974 5.96821 7.16288 -22.7812 5.828 +396 1 5.1207 7.60724 5.96887 -13.0365 8.36981 -2.80723 +397 1 6.90344 6.91817 5.14994 -0.204819 -5.34708 -0.858742 +398 1 7.6747 7.73724 5.15589 4.74286 -4.17129 0.509029 +399 1 7.64232 6.7419 6.03772 18.4896 23.5989 -0.89996 +400 1 6.75496 7.62762 6.01659 7.03025 5.11039 1.24431 +401 1 0.0963896 0.0201086 6.80553 -1.40648 -0.449972 0.0493894 +402 1 0.835843 0.891839 6.79877 7.20248 -7.32555 0.745706 +403 1 0.918901 8.53581 7.64787 -17.0565 2.54879 17.4592 +404 1 0.0577403 0.896342 7.73471 1.30728 -4.31515 -1.61795 +405 1 1.61051 8.45024 6.92242 29.7484 14.9171 -14.6755 +406 1 2.47578 0.885204 6.88627 1.39053 -1.86497 -2.40181 +407 1 2.50444 0.0274811 7.76899 5.04636 2.83552 -7.66004 +408 1 1.76075 0.832954 7.77629 -9.26653 -0.311946 -7.26081 +409 1 3.50837 8.51457 6.78791 -7.98313 -6.7176 0.868776 +410 1 4.17648 0.757665 6.93195 8.57719 11.9693 -2.56623 +411 1 4.23832 0.0657272 7.77237 -2.00114 -7.83956 -8.62893 +412 1 3.37339 0.86481 7.76894 -4.57993 4.49098 -10.8865 +413 1 5.14407 0.0592801 6.76072 -1.57797 -1.16589 1.03837 +414 1 5.93853 0.879814 6.88423 6.63031 -4.29327 -1.40131 +415 1 6.03919 8.48714 7.63222 -2.96915 1.1039 1.2166 +416 1 5.15255 0.794385 7.73799 -0.425319 2.1861 -1.28188 +417 1 6.89313 0.0918814 6.89086 -1.49841 -3.77335 -3.98868 +418 1 7.61212 0.939213 6.80354 8.77263 -4.1407 2.30253 +419 1 7.70899 8.53849 7.72172 -1.01623 -1.03696 -1.75272 +420 1 6.83169 0.853131 7.69229 0.514071 1.96118 2.47006 +421 1 0.0995377 1.63996 6.92907 -20.9698 6.48021 -16.3567 +422 1 0.856061 2.59196 6.8009 3.6314 -4.45866 -1.95318 +423 1 0.7986 1.79168 7.64825 21.262 -5.45904 12.6361 +424 1 0.086833 2.5674 7.63497 -11.6486 2.30739 1.5806 +425 1 1.65946 1.72494 6.90853 -2.96091 -3.71884 -7.8878 +426 1 2.55175 2.62076 6.77199 1.34599 -1.3093 4.14575 +427 1 2.49264 1.73911 7.61263 5.68035 -0.198489 5.50404 +428 1 1.73023 2.55227 7.60126 -2.61513 6.16936 5.4644 +429 1 3.34887 1.7831 6.78557 0.7181 -0.718938 0.35045 +430 1 4.23104 2.60662 6.78869 6.67274 -5.2978 -0.800832 +431 1 4.35855 1.74494 7.60411 -4.34125 -3.35913 2.62052 +432 1 3.36542 2.60589 7.78048 1.27821 -1.57097 -4.57229 +433 1 5.20004 1.65594 6.83168 -6.03666 5.50106 2.07188 +434 1 5.95504 2.56783 6.93549 0.704503 2.20695 -11.5481 +435 1 6.05448 1.73837 7.6627 -1.83376 -2.83098 2.15288 +436 1 5.1146 2.5438 7.6124 2.3372 -0.290906 4.36925 +437 1 6.88113 1.721 6.77631 -7.16431 5.43568 2.84999 +438 1 7.667 2.62761 6.74793 2.83097 -7.51196 9.4855 +439 1 7.73348 1.72515 7.754 -4.1563 0.657477 -6.03723 +440 1 6.7624 2.63316 7.64937 6.65302 -0.565372 4.94425 +441 1 0.0849859 3.37793 6.84942 -10.0386 4.11872 -3.53604 +442 1 0.857904 4.2895 6.93068 1.24699 0.504054 -2.41984 +443 1 0.822866 3.35005 7.62376 7.62204 5.76535 8.89189 +444 1 0.0609986 4.27823 7.72873 -1.62474 0.278416 -2.41968 +445 1 1.65771 3.45598 6.89789 2.67743 0.0202624 -2.34558 +446 1 2.54508 4.23374 6.86348 0.989961 3.94158 3.39783 +447 1 2.51344 3.50821 7.77131 2.79285 -8.19104 -6.06353 +448 1 1.76675 4.31871 7.74484 -7.62178 -3.47349 -5.94274 +449 1 3.46999 3.3444 6.87805 -6.49672 7.19856 -0.129806 +450 1 4.27761 4.20284 6.7963 2.00695 2.57497 4.55692 +451 1 4.36643 3.33193 7.71738 -5.18938 3.59254 -0.980407 +452 1 3.39117 4.21736 7.78484 2.56803 1.85612 -2.81745 +453 1 5.17851 3.50703 6.80054 -0.562057 -4.69817 1.35476 +454 1 5.91855 4.34694 6.82856 20.1656 -16.4219 -1.68121 +455 1 5.94421 3.41917 7.73472 -0.686701 1.44481 -0.413888 +456 1 5.21752 4.35256 7.70192 -2.57704 -7.73472 4.05334 +457 1 6.81349 3.41173 6.82265 -1.40277 6.3135 5.01717 +458 1 7.75813 4.35693 6.90395 -1.64702 -1.61669 -0.476323 +459 1 7.7614 3.35066 7.72289 -1.59004 1.58238 -2.0122 +460 1 6.90386 4.19648 7.73719 0.143217 3.47184 -3.3084 +461 1 8.51568 5.21538 6.91302 4.27065 -2.85002 -1.50895 +462 1 0.951652 6.01174 6.9207 -11.7991 -7.13131 -18.8927 +463 1 0.936182 5.16144 7.77632 -7.30596 -5.41004 -9.74737 +464 1 0.00163562 6.07485 7.63199 0.624183 -4.07361 5.99132 +465 1 1.66533 5.15284 6.74597 2.96466 -1.56742 2.06772 +466 1 2.61909 5.93515 6.89385 -1.40662 1.18192 -1.24787 +467 1 2.46927 5.13962 7.72554 6.76967 2.2802 -3.81441 +468 1 1.64453 6.02831 7.68681 19.7677 -7.24739 11.5441 +469 1 3.40343 5.06011 6.8889 -0.198511 0.401262 -0.796323 +470 1 4.30752 6.01937 6.85588 -10.789 -11.9311 3.49788 +471 1 4.28416 5.14222 7.62835 0.609452 -0.263512 0.8346 +472 1 3.47645 6.07368 7.70428 -7.22384 -10.7657 -0.906726 +473 1 5.22078 5.0656 6.90915 -18.0053 20.6161 -6.39 +474 1 5.99499 5.93089 6.77083 3.48021 13.0571 15.6598 +475 1 6.05342 5.21794 7.69617 -5.52282 -4.0969 2.40523 +476 1 5.15908 5.93838 7.59985 0.288818 1.34614 5.01043 +477 1 6.82844 5.21514 6.92244 2.6589 -10.3439 -6.80084 +478 1 7.65444 5.90306 6.73997 5.39846 9.09532 17.1635 +479 1 7.73871 5.1328 7.74827 -11.0217 0.411956 -11.9718 +480 1 6.85057 5.9849 7.66627 -2.19779 2.18231 4.19621 +481 1 8.49223 6.85953 6.88515 0.63092 3.61848 -3.8326 +482 1 0.912061 7.72558 6.80554 -14.7372 -15.0451 -0.530208 +483 1 0.94972 6.80465 7.60047 -8.86666 17.9559 7.11774 +484 1 0.0485157 7.69847 7.76952 0.871021 -3.29928 -3.01128 +485 1 1.7395 6.92207 6.74618 -0.216972 -4.99493 2.92958 +486 1 2.48517 7.73307 6.85664 4.02861 0.442708 -0.186237 +487 1 2.60224 6.86957 7.70226 -2.68029 -0.280597 -1.3011 +488 1 1.75659 7.71058 7.78997 -12.217 -12.015 -24.8657 +489 1 3.36601 6.81921 6.83807 2.83617 1.11452 1.50668 +490 1 4.30578 7.6333 6.9198 -11.3388 0.787746 -11.6868 +491 1 4.17656 6.84912 7.75346 9.62737 7.65922 -1.79281 +492 1 3.37828 7.72239 7.62462 0.544776 0.263736 1.68806 +493 1 5.03666 6.75188 6.83201 10.5371 18.8221 7.02157 +494 1 5.88561 7.69892 6.74579 2.44744 2.75196 7.83 +495 1 6.02886 6.89217 7.71335 -1.94107 -2.07696 0.28038 +496 1 5.05253 7.6432 7.63466 10.7152 0.484071 10.517 +497 1 6.76592 6.82276 6.85512 1.71624 -1.12004 -2.46021 +498 1 7.63682 7.73046 6.77254 1.37903 -1.27982 -0.239663 +499 1 7.60482 6.74157 7.76697 8.04118 12.5638 -12.9988 +500 1 6.86424 7.69163 7.60229 0.0588858 0.119654 2.66424 +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +500 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 8.2207069144348992e+00 +0.0000000000000000e+00 8.2207069144348992e+00 +0.0000000000000000e+00 8.2207069144348992e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 0.0109462 8.19276 8.15872 -2.39444 9.6729 7.55614 +2 1 0.913757 0.79291 0.0997863 -14.8553 6.06953 -19.2131 +3 1 0.922041 0.00329478 0.797424 -4.57303 -13.0314 3.29774 +4 1 0.0667547 0.768895 0.898382 -4.60646 8.57627 -8.38591 +5 1 1.74036 8.13245 0.0766359 -17.8989 17.5469 -5.09772 +6 1 2.47269 0.889925 0.0248853 -5.42566 -21.0007 -17.6291 +7 1 2.46322 8.1233 0.872599 4.75898 11.1097 -4.77186 +8 1 1.65846 0.837491 0.791152 15.1363 -5.40511 14.9864 +9 1 3.32881 8.19546 0.053156 -13.3342 -9.93994 -9.94684 +10 1 4.03279 0.760382 0.00184897 9.91793 7.67217 -5.53917 +11 1 4.13378 8.169 0.732239 -0.574085 -2.22965 11.4349 +12 1 3.20922 0.774467 0.746193 11.6707 -5.4973 20.7036 +13 1 4.84922 8.194 8.14339 7.30804 6.79019 8.16024 +14 1 5.8218 0.772541 8.17358 -10.0231 -1.2549 7.34514 +15 1 5.68256 8.16785 0.77714 3.02512 1.45358 -0.272422 +16 1 4.85759 0.84201 0.746179 4.61671 -0.701957 -1.77598 +17 1 6.62546 8.16087 8.21828 -7.1959 6.90651 13.7327 +18 1 7.47259 0.88807 0.0569708 -4.40901 -2.93179 -3.05075 +19 1 7.47431 0.0411346 0.771198 -11.1102 -3.58532 -4.76152 +20 1 6.57656 0.847149 0.913044 26.339 -17.4997 -36.7448 +21 1 8.18759 1.70398 8.18761 4.1072 -0.492398 0.811998 +22 1 0.899666 2.41042 8.17073 -11.5274 -4.75425 3.68191 +23 1 0.850302 1.72005 0.839978 5.34352 -14.6759 -1.78579 +24 1 0.0603398 2.39798 0.844681 -8.60658 17.5352 -6.64359 +25 1 1.71223 1.59237 0.0242378 -11.0164 14.7761 -6.28233 +26 1 2.39934 2.5183 0.00540478 8.02997 -3.83137 6.03634 +27 1 2.48112 1.56604 0.834626 2.61805 16.1266 0.364368 +28 1 1.6143 2.50502 0.831093 22.9512 -23.9291 -18.4162 +29 1 3.30714 1.5456 0.0352888 3.02185 20.9324 -4.02492 +30 1 4.17998 2.44319 8.21567 -15.5858 -1.30182 -5.2994 +31 1 4.13571 1.72982 0.900024 -11.4398 -17.9409 -9.12775 +32 1 3.31093 2.54257 0.820203 -10.3368 -11.5392 -3.6507 +33 1 5.0044 1.71067 8.16991 -2.52586 -20.2729 12.2321 +34 1 5.83707 2.42978 0.0552544 -9.07217 4.33101 -1.43054 +35 1 5.68958 1.61323 0.87339 20.6627 3.79367 -24.2404 +36 1 4.88712 2.41203 0.783075 18.227 14.4306 8.63131 +37 1 6.51234 1.55641 0.0925838 9.00513 9.77167 -3.15357 +38 1 7.38894 2.55021 8.21638 -3.89162 -5.39246 1.97695 +39 1 7.3932 1.68143 0.910549 14.6159 -16.4356 -32.9418 +40 1 6.52029 2.5195 0.875176 1.21021 -6.27577 -1.18313 +41 1 0.0178952 3.25358 8.17469 3.31384 23.2108 27.1434 +42 1 0.75874 4.10726 8.14569 6.02202 2.9315 8.91628 +43 1 0.895393 3.22207 0.752637 -27.1078 14.1691 0.641871 +44 1 8.18599 4.06691 0.900855 -0.259841 0.495686 -5.35481 +45 1 1.55285 3.22874 8.15747 6.98433 26.3863 8.64396 +46 1 2.49624 4.20319 8.19485 -11.6121 -5.75058 -7.87094 +47 1 2.42547 3.30302 0.888339 10.6882 -12.4594 -2.99107 +48 1 1.6862 4.0108 0.835279 -13.347 15.0654 -7.27246 +49 1 3.22 3.33904 0.0153378 4.70565 -17.4148 -11.2872 +50 1 4.15099 4.01359 0.0472035 -3.25232 -0.128895 -8.82814 +51 1 4.06799 3.24916 0.843927 9.3476 8.05351 2.04714 +52 1 3.19501 4.05 0.736238 12.2088 14.8797 22.981 +53 1 4.93359 3.21205 8.21538 5.02686 8.32666 2.39487 +54 1 5.81852 4.10681 0.0313505 -9.96067 16.6194 -8.35941 +55 1 5.78406 3.36669 0.776887 -2.74739 -9.47942 10.9149 +56 1 4.90983 4.0411 0.864362 0.837356 4.14382 -0.368312 +57 1 6.53897 3.36302 8.19911 9.90234 -20.173 11.5285 +58 1 7.46276 4.04697 0.0534703 -5.76424 1.73449 -3.50806 +59 1 7.34501 3.24442 0.827453 2.34892 5.8087 4.09531 +60 1 6.59021 4.15121 0.905225 -2.44603 -12.1461 -5.89568 +61 1 8.13258 4.93013 0.0905402 6.61239 1.0085 -5.83678 +62 1 0.918786 5.84938 8.18896 -100.34 -125.435 4.75603 +63 1 0.733666 4.90689 0.894865 5.0782 -1.1493 -19.9038 +64 1 8.13743 5.78012 0.885656 21.4143 -27.2006 -30.8387 +65 1 1.67225 4.91657 0.0765019 -6.36422 -5.41993 -9.68754 +66 1 2.43163 5.74665 8.16344 0.0454169 7.36314 0.282499 +67 1 2.52248 4.94902 0.779546 -17.0632 -3.92502 5.40756 +68 1 1.68817 5.73221 0.738326 -10.7061 -22.6586 25.0306 +69 1 3.20519 4.98792 8.20267 13.0471 -20.6699 18.764 +70 1 4.1645 5.8475 0.0144516 -41.0284 -51.2746 -22.2701 +71 1 4.12065 4.85332 0.726813 -6.7392 5.54296 9.04283 +72 1 3.22358 5.72978 0.902951 13.2902 6.38408 -11.6219 +73 1 4.86923 4.9681 8.18768 10.2044 -1.77915 -2.81852 +74 1 5.77301 5.70687 8.13281 -22.5863 16.9623 33.7246 +75 1 5.78731 4.97674 0.770243 -6.25016 -2.29075 -2.78772 +76 1 4.89256 5.78932 0.733037 29.9716 -43.8231 39.093 +77 1 6.61696 5.02048 8.19969 -11.3595 -28.891 -1.36328 +78 1 7.33645 5.74186 0.0277988 27.1444 12.1113 -11.7126 +79 1 7.32557 4.92161 0.798933 6.38759 1.63603 8.88722 +80 1 6.60198 5.76847 0.724174 -12.087 6.06842 22.1567 +81 1 0.0632305 6.4911 0.00261304 -6.53376 9.85675 7.22968 +82 1 0.730752 7.3973 8.19101 19.8665 -4.89129 14.6872 +83 1 0.894205 6.53954 0.906348 -15.672 -5.70878 -18.8817 +84 1 0.0916376 7.35116 0.914882 -39.3163 -12.8553 -54.9509 +85 1 1.54844 6.4779 0.0899714 109.204 121.919 -0.90408 +86 1 2.45374 7.43343 8.1677 17.1682 -16.9212 2.53497 +87 1 2.38485 6.48495 0.871503 16.8711 24.0952 -19.5071 +88 1 1.73482 7.30198 0.918245 -4.50526 25.4363 -21.6583 +89 1 3.35837 6.52948 0.00621289 -17.9347 4.05163 8.57797 +90 1 4.15544 7.30314 8.17418 -3.86421 14.3399 10.028 +91 1 4.18078 6.49797 0.807337 -33.0181 25.5019 29.3461 +92 1 3.28881 7.33369 0.840128 0.0678552 -0.60668 -1.16807 +93 1 4.86711 6.50097 0.0644243 55.2704 56.5162 -42.5456 +94 1 5.6807 7.37537 8.15497 2.37339 1.6253 6.06405 +95 1 5.83906 6.54647 0.813774 -8.31017 -0.439493 -0.862375 +96 1 4.90102 7.33548 0.785855 3.38301 3.17369 4.3776 +97 1 6.62594 6.60016 8.16507 -28.5529 -10.5165 29.461 +98 1 7.41236 7.32596 8.18119 12.8158 16.6867 22.5272 +99 1 7.48788 6.57526 0.906715 -17.6408 15.7915 -12.9219 +100 1 6.60846 7.32088 0.891813 -2.23221 1.45701 -6.99196 +101 1 8.17 8.13088 1.54543 21.7946 28.0076 23.7334 +102 1 0.889634 0.755106 1.5647 -2.22366 9.82139 12.4406 +103 1 0.787312 0.00367743 2.47285 9.7959 7.14049 -7.07183 +104 1 0.0399172 0.910289 2.54829 -10.4426 -54.7685 -48.8923 +105 1 1.70161 0.076186 1.70291 0.655659 -5.9987 -1.53887 +106 1 2.5425 0.840944 1.65312 -5.39214 -2.71573 1.42057 +107 1 2.39333 0.0846015 2.56412 19.1459 -13.6703 -26.8796 +108 1 1.62991 0.895915 2.55976 -9.37186 -8.23605 -42.2796 +109 1 3.3255 0.037006 1.60354 -4.30714 4.73223 -3.06839 +110 1 4.20236 0.841896 1.65063 -10.9567 4.39501 -2.76043 +111 1 4.12511 8.16508 2.38147 6.48597 31.2032 29.2026 +112 1 3.37125 0.822661 2.38548 -3.89508 0.169143 6.57094 +113 1 4.86677 0.028066 1.55007 9.3902 -7.55136 2.71818 +114 1 5.8528 0.805894 1.56988 -29.5994 -6.3857 29.2326 +115 1 5.73944 8.2048 2.38025 -0.334985 15.3443 16.2286 +116 1 4.92058 0.739392 2.48512 1.8123 5.57771 -0.399822 +117 1 6.61747 8.14877 1.63757 -7.92973 14.3058 -0.0863647 +118 1 7.37923 0.805843 1.70616 17.0436 -4.06349 -13.2175 +119 1 7.38533 8.17909 2.55221 2.10247 4.05286 -21.3656 +120 1 6.66981 0.91359 2.42776 -18.0385 -1.7859 9.16667 +121 1 8.21433 1.71804 1.64878 9.58557 -8.70073 -6.06848 +122 1 0.91795 2.50647 1.62107 -49.2165 -42.2319 12.3144 +123 1 0.778719 1.62612 2.3667 15.8366 8.16624 0.723179 +124 1 0.0388825 2.56454 2.43408 -0.65123 -11.9302 4.78295 +125 1 1.70614 1.64161 1.56714 -4.83448 1.54656 8.88708 +126 1 2.55772 2.51525 1.68348 -33.0305 -26.0768 -4.05159 +127 1 2.46774 1.68666 2.4295 -0.728639 -2.90689 1.14987 +128 1 1.58495 2.48207 2.53043 32.1395 -14.2129 -42.8967 +129 1 3.28639 1.69638 1.58862 0.141668 -5.07807 4.69228 +130 1 4.07581 2.46356 1.66204 5.75617 5.24573 6.028 +131 1 4.09064 1.65395 2.45941 5.06207 -1.15698 -3.64398 +132 1 3.2978 2.42597 2.51229 -0.392826 8.06961 -8.70923 +133 1 4.99952 1.60143 1.58928 -25.5713 -7.8385 22.8567 +134 1 5.66634 2.3835 1.71386 21.3679 17.6667 -19.1597 +135 1 5.74656 1.70527 2.50917 3.11288 -14.4009 7.07914 +136 1 4.97163 2.46224 2.45828 -14.3686 2.77193 11.4917 +137 1 6.62989 1.62285 1.56611 -20.0211 14.8617 27.1541 +138 1 7.37036 2.42163 1.58976 1.23932 26.194 15.084 +139 1 7.49234 1.71782 2.38524 -11.5645 -3.14792 16.0927 +140 1 6.57493 2.44646 2.50738 3.76278 -0.484364 -1.65815 +141 1 8.13855 3.28395 1.66364 9.95915 -4.6352 -13.1677 +142 1 0.822632 4.13968 1.61013 -1.66869 -18.1546 6.90643 +143 1 0.836195 3.27368 2.50106 -4.0013 3.27813 -2.23185 +144 1 0.00706469 4.04664 2.42415 6.78153 4.66429 11.0832 +145 1 1.56864 3.19926 1.57501 43.2252 54.2341 22.2486 +146 1 2.37435 4.19613 1.65007 19.5365 -23.6872 -5.11708 +147 1 2.53204 3.33272 2.45976 -10.1616 -1.37273 8.96239 +148 1 1.5958 4.02298 2.45513 4.44558 4.83545 -0.957126 +149 1 3.24862 3.20562 1.71329 33.7169 30.1535 -8.86948 +150 1 4.04966 4.11271 1.69147 14.455 0.133261 -16.0308 +151 1 4.17313 3.29199 2.42566 -5.80506 -5.3643 5.35172 +152 1 3.37886 4.04594 2.4591 -12.864 4.86539 14.8631 +153 1 5.00029 3.3715 1.7428 -16.124 -51.6521 -51.6846 +154 1 5.71525 4.10565 1.71106 18.126 11.5713 -25.6554 +155 1 5.67368 3.37853 2.52254 40.5036 -38.7002 16.4445 +156 1 4.98188 4.047 2.42098 -44.4942 70.6847 47.3189 +157 1 6.52567 3.216 1.71371 -0.385424 4.96723 -0.762826 +158 1 7.40007 4.08176 1.73877 -6.32286 -1.56827 -20.7524 +159 1 7.42837 3.30042 2.4503 -10.1629 -6.83382 9.16894 +160 1 6.52178 4.09551 2.40152 8.21405 -5.0269 3.15343 +161 1 0.00699263 4.85762 1.69229 -17.0824 5.05692 -6.94595 +162 1 0.756152 5.6631 1.60232 14.3979 15.6472 -4.59775 +163 1 0.764682 4.99903 2.39299 18.2885 -21.5851 21.4239 +164 1 0.0800264 5.75765 2.41619 -22.1201 11.2764 3.26076 +165 1 1.60226 4.84293 1.69094 -9.96687 23.2298 -5.36928 +166 1 2.38001 5.77059 1.56073 -4.13582 -26.0328 27.2432 +167 1 2.39304 4.87599 2.45449 3.86796 9.40324 7.0282 +168 1 1.5595 5.8443 2.45554 15.3251 -19.3503 -10.1983 +169 1 3.24805 4.8639 1.55208 5.72697 0.833939 9.91621 +170 1 4.12523 5.83768 1.72183 2.66681 -7.18069 -9.93584 +171 1 4.14719 4.98927 2.48442 -5.36599 -4.29088 6.08995 +172 1 3.29103 5.75037 2.41213 -9.14312 -21.8308 11.1485 +173 1 4.88531 4.96658 1.71552 5.62499 -3.03462 -8.19539 +174 1 5.80164 5.66001 1.66617 -22.0309 23.7646 0.752493 +175 1 5.79599 4.88622 2.4436 -18.3543 9.31939 -6.6266 +176 1 4.94007 5.78406 2.4889 7.47518 -6.1933 -6.95152 +177 1 6.50282 4.96059 1.57437 23.9581 -12.4339 8.07292 +178 1 7.43162 5.77666 1.60532 -16.9632 -9.02864 21.2089 +179 1 7.30902 4.88901 2.38072 1.39073 12.4251 10.603 +180 1 6.52191 5.81931 2.5443 7.19321 -57.902 -45.2674 +181 1 0.0825324 6.49799 1.58172 -0.0568703 17.3702 26.5223 +182 1 0.807327 7.40344 1.54436 38.413 9.53604 44.8678 +183 1 0.85313 6.5885 2.46372 -17.206 13.7674 -10.0743 +184 1 0.0766958 7.42441 2.49843 -14.0409 -5.69227 -10.6889 +185 1 1.56626 6.64679 1.65111 17.2201 -21.881 29.7832 +186 1 2.51758 7.48828 1.7101 -1.12703 -9.37355 7.34939 +187 1 2.48642 6.48139 2.37761 -17.45 9.10758 18.4987 +188 1 1.62607 7.39059 2.4668 5.47881 2.11068 -4.08662 +189 1 3.22096 6.48273 1.68127 15.0894 18.1205 -19.6751 +190 1 4.01435 7.47003 1.70259 9.92584 -36.0532 -31.9009 +191 1 4.01053 6.48307 2.56537 4.58494 43.5966 -38.8488 +192 1 3.31708 7.46346 2.49246 -11.1632 -6.704 4.9273 +193 1 4.97912 6.56412 1.70872 -0.0323444 1.40088 -5.51009 +194 1 5.76314 7.42951 1.73429 -4.71194 -18.4847 -18.3917 +195 1 5.75053 6.57569 2.52583 -15.5416 2.95473 -19.9489 +196 1 4.86788 7.33538 2.51839 21.348 1.25465 -21.9702 +197 1 6.54919 6.48383 1.72129 1.36669 8.74928 -8.3147 +198 1 7.40692 7.48075 1.59274 -4.17636 -24.5364 8.08039 +199 1 7.31105 6.49008 2.55841 18.9084 8.98379 -5.81349 +200 1 6.56124 7.4093 2.46898 3.88266 -3.866 3.64736 +201 1 0.0467578 0.0587236 3.25639 -2.58837 -3.06001 8.14477 +202 1 0.919472 0.840587 3.2901 -13.7955 -3.94396 11.0802 +203 1 0.913851 8.17129 4.10222 -17.0314 2.36091 -15.061 +204 1 8.12452 0.831674 4.11824 2.96137 1.66258 0.705395 +205 1 1.72266 8.12268 3.2983 -16.5809 -0.000561518 15.0322 +206 1 2.36681 0.848699 3.23189 33.3023 -3.20785 26.2082 +207 1 2.52451 0.093755 4.0501 -20.4816 -4.23237 16.7496 +208 1 1.57332 0.89934 4.17862 1.65408 -10.4059 -4.79402 +209 1 3.23411 8.18086 3.33998 20.9401 7.85353 -15.8307 +210 1 4.12777 0.912462 3.28751 -3.54395 -8.15241 -0.704223 +211 1 4.05479 8.16789 4.17086 6.43266 7.42359 -18.6916 +212 1 3.3412 0.763098 4.14988 -8.17365 16.5822 -19.2151 +213 1 4.85923 8.19378 3.30398 3.75427 6.29815 -1.39384 +214 1 5.723 0.836221 3.31262 4.07436 -7.7371 -12.3645 +215 1 5.78765 0.0695661 4.10746 2.41957 -4.40965 -1.14115 +216 1 4.97909 0.892899 4.12401 -13.5931 -16.8127 1.66952 +217 1 6.57108 0.0657357 3.30807 -10.4223 -10.045 -0.47006 +218 1 7.35373 0.738008 3.24493 15.9915 16.7978 9.43624 +219 1 7.34677 0.0332152 4.15763 12.3358 5.5849 -5.20193 +220 1 6.67147 0.918341 4.12524 -9.23951 -11.4667 0.577623 +221 1 0.0788919 1.58016 3.21314 -1.55258 49.5779 50.5391 +222 1 0.904188 2.40885 3.22233 -31.0956 -2.82504 30.7646 +223 1 0.877149 1.74225 4.15165 7.55452 -10.7555 -4.03202 +224 1 0.0936835 2.40444 4.16194 -19.0736 7.56858 -3.47745 +225 1 1.71236 1.61805 3.29179 -19.7602 28.7111 2.45155 +226 1 2.5486 2.41776 3.31547 -43.6679 25.9149 -16.2942 +227 1 2.39734 1.55251 4.06577 15.8032 7.53109 12.4652 +228 1 1.72237 2.5181 4.15876 -10.7679 -10.2774 -3.05137 +229 1 3.23039 1.71099 3.29502 25.8646 -44.0791 -9.55739 +230 1 4.12827 2.45813 3.1934 -6.48806 -10.3202 8.62038 +231 1 4.19407 1.63495 4.09603 -15.4993 6.39445 10.1662 +232 1 3.20761 2.36838 4.07177 19.5744 11.0493 29.9438 +233 1 4.94979 1.63514 3.37535 1.21152 5.67416 -27.5114 +234 1 5.82776 2.47766 3.34313 -3.66364 1.42568 -1.20833 +235 1 5.76542 1.58538 4.03513 14.4098 19.4192 12.2978 +236 1 4.95489 2.43394 4.07273 -1.13246 5.06376 7.36624 +237 1 6.661 1.60077 3.30919 -3.43354 8.94885 -5.94598 +238 1 7.49515 2.56092 3.28033 -10.5336 -12.2625 1.51454 +239 1 7.39275 1.71767 4.16117 3.5537 3.96098 0.811537 +240 1 6.54244 2.56469 4.20941 11.0399 -32.6669 -26.4629 +241 1 8.2116 3.30444 3.37137 5.74747 4.63382 -14.2394 +242 1 0.840624 4.14226 3.27407 -5.48884 -5.61804 0.498093 +243 1 0.734437 3.23139 4.08576 22.8281 5.93798 4.2063 +244 1 0.0471721 4.13123 4.11158 -4.3827 3.27424 0.087671 +245 1 1.70286 3.20807 3.23042 -2.96775 14.0769 10.9943 +246 1 2.38769 4.13105 3.27446 4.88078 -2.82576 -1.60425 +247 1 2.4087 3.28686 4.02353 16.6104 0.201322 7.1777 +248 1 1.69983 4.0678 4.13415 -10.6977 3.91895 2.19645 +249 1 3.34377 3.23634 3.36851 -11.3528 1.51526 -17.2895 +250 1 4.2055 4.03294 3.37597 -23.3492 5.34016 -26.85 +251 1 4.03955 3.26203 4.11941 11.7033 -4.94552 16.1773 +252 1 3.21963 4.01243 4.16102 5.66091 6.82551 -5.40832 +253 1 4.83261 3.19517 3.32313 20.1816 8.52525 -2.26656 +254 1 5.77148 4.16495 3.28824 -31.489 -26.7787 -6.90732 +255 1 5.82425 3.30115 4.19401 -37.1473 -6.40083 -11.3511 +256 1 4.87724 4.09609 4.11549 36.2568 -10.3151 3.06059 +257 1 6.58329 3.33973 3.22197 0.0461967 -7.66729 -2.40242 +258 1 7.43644 4.05966 3.30265 -3.56999 5.92726 -1.37248 +259 1 7.48286 3.29775 4.19646 -3.89008 -9.4431 -11.0777 +260 1 6.47907 4.03353 4.01383 29.8324 22.3851 15.73 +261 1 8.15241 5.02846 3.31122 10.6595 -5.28085 -5.36552 +262 1 0.804631 5.8376 3.20576 13.4276 -32.1322 14.0647 +263 1 0.877129 4.8969 4.13251 -1.47043 5.42126 -0.0257482 +264 1 0.0651636 5.75976 4.1954 -9.31697 -6.72952 -15.907 +265 1 1.57617 4.92532 3.28718 5.51341 5.68743 -3.59864 +266 1 2.42583 5.72219 3.30114 4.35376 1.25963 -4.44713 +267 1 2.4551 4.89394 4.08913 0.180251 2.9051 2.6698 +268 1 1.67099 5.80732 4.08057 -5.18981 -1.73911 5.86888 +269 1 3.33413 4.84944 3.32334 -2.55875 1.02427 -1.99572 +270 1 4.20493 5.83452 3.24979 -21.4386 -63.3893 34.6056 +271 1 4.19181 4.8901 4.01924 -15.0952 14.1984 13.5631 +272 1 3.36551 5.83759 4.08786 -9.40985 -16.2604 3.57159 +273 1 4.9921 4.89151 3.36329 -7.1819 8.21085 -25.7306 +274 1 5.77026 5.74279 3.2372 -19.2661 -13.3988 15.8911 +275 1 5.68576 4.90444 4.10854 12.1482 9.27276 4.35592 +276 1 4.84395 5.80423 4.20869 23.9245 -11.025 -23.296 +277 1 6.4858 4.83859 3.18898 36.5327 24.7135 15.3623 +278 1 7.30315 5.68446 3.36881 -0.385614 18.5722 -20.0571 +279 1 7.37309 4.9455 4.05168 -2.3203 -17.2743 20.9328 +280 1 6.63896 5.83294 4.18727 -7.1922 -10.1498 -0.517575 +281 1 0.0942908 6.52233 3.3159 -35.7657 14.4096 -15.937 +282 1 0.836387 7.40457 3.20726 4.47284 -0.4112 17.4557 +283 1 0.739312 6.64758 4.08638 39.4722 -18.3951 12.5032 +284 1 8.21631 7.30153 4.06221 -15.2581 27.9702 -0.672668 +285 1 1.58758 6.54973 3.25882 10.9016 11.7867 8.01769 +286 1 2.56536 7.3619 3.34369 -76.1678 6.55793 -73.9603 +287 1 2.52556 6.61112 4.10224 -30.5256 -34.6487 7.0656 +288 1 1.62124 7.32393 4.18622 0.536802 -1.56833 -6.92191 +289 1 3.3681 6.64037 3.37818 -8.53205 -51.1792 -62.7851 +290 1 4.15298 7.36163 3.20593 -21.9528 4.612 22.3686 +291 1 4.12464 6.54108 4.035 14.4356 20.1369 22.2034 +292 1 3.19906 7.31073 4.01315 82.3215 73.9575 117.35 +293 1 4.9065 6.52075 3.26638 28.3768 26.425 6.32862 +294 1 5.74138 7.36096 3.25092 -0.970474 8.69807 4.03129 +295 1 5.81652 6.58456 4.03756 -14.737 -0.580193 0.741413 +296 1 4.87586 7.39212 4.03191 6.20313 -4.00572 5.92319 +297 1 6.48611 6.49412 3.21889 20.5434 47.1119 52.8917 +298 1 7.41876 7.4098 3.23912 -0.409624 -8.77258 11.2401 +299 1 7.35972 6.63444 4.07034 1.58562 -5.33459 -2.2315 +300 1 6.64271 7.48657 4.18074 -12.6903 -3.8877 -6.90745 +301 1 8.18545 0.00495327 4.98201 0.835961 10.4978 -8.83054 +302 1 0.830861 0.760813 4.98094 -9.95647 8.66756 -7.1447 +303 1 0.808969 0.00641337 5.74397 -4.48252 1.30502 4.67537 +304 1 0.018812 0.795135 5.84676 0.988121 0.902183 -11.1018 +305 1 1.60862 0.0119183 4.84308 17.0508 -2.91068 17.4808 +306 1 2.50239 0.876955 4.96833 -9.09304 -5.08176 -4.69214 +307 1 2.44832 8.14323 5.81234 6.77585 9.13889 -19.0494 +308 1 1.56911 0.731109 5.75394 17.4698 11.7404 -4.99849 +309 1 3.28793 0.0458368 4.91142 -7.08209 -9.95818 14.0315 +310 1 4.07208 0.823519 4.87126 26.6153 -9.6486 13.2451 +311 1 4.06672 0.0477209 5.80002 10.3282 0.566915 -15.466 +312 1 3.2042 0.88056 5.78404 3.8932 -8.75566 -1.61055 +313 1 5.02696 0.0222739 4.88991 -12.0715 4.27124 3.2294 +314 1 5.73734 0.886325 4.85298 9.71713 -6.59089 13.6933 +315 1 5.79543 0.0389128 5.76135 -3.4407 3.92019 -0.496418 +316 1 4.85161 0.780997 5.82861 2.47749 38.2945 -34.2513 +317 1 6.64858 0.0906911 4.97808 -13.982 -18.784 -13.0607 +318 1 7.30429 0.900733 5.00382 63.7384 -13.5798 -32.445 +319 1 7.4114 8.15633 5.76261 6.64498 1.40027 -2.33346 +320 1 6.66824 0.783026 5.72649 -29.5414 5.85716 47.7215 +321 1 0.0281683 1.66949 4.95949 -0.425666 -3.96058 2.91208 +322 1 0.893447 2.47998 4.9969 -1.93266 1.10148 -5.4469 +323 1 0.843715 1.6221 5.7589 -0.766033 4.56211 -3.21682 +324 1 0.0782454 2.53663 5.73256 -1.35265 -11.3593 -4.90859 +325 1 1.65079 1.66704 4.93767 -0.533365 0.139965 4.11876 +326 1 2.51601 2.38441 4.90805 0.649871 6.98133 -0.140965 +327 1 2.41175 1.72195 5.72474 2.84663 -8.86686 7.73621 +328 1 1.61538 2.54316 5.81674 -0.089029 -19.7728 -12.4678 +329 1 3.35891 1.54703 4.95536 -9.48818 22.4331 -2.56554 +330 1 4.08195 2.54313 5.01426 16.1748 -2.70068 -21.0768 +331 1 4.12034 1.74262 5.81366 10.5637 -13.2904 -3.74489 +332 1 3.37175 2.4672 5.72729 -31.5422 -3.32565 13.6818 +333 1 5.0033 1.68848 4.95948 -13.0392 -13.8401 -3.80319 +334 1 5.66589 2.47997 4.89515 25.4212 2.24436 -8.70857 +335 1 5.79028 1.55903 5.82666 2.05757 18.2253 -24.3713 +336 1 5.0311 2.46113 5.68951 -16.9377 1.04 21.5338 +337 1 6.57827 1.56896 5.01204 -21.5711 32.5342 -4.2816 +338 1 7.31623 2.52382 4.98258 18.6955 -8.52314 -2.25127 +339 1 7.45461 1.64332 5.76278 -16.0261 1.47893 -16.982 +340 1 6.64089 2.42957 5.78128 -11.0128 0.688597 0.00936653 +341 1 0.0932375 3.33117 4.94446 -5.57952 -6.38154 1.87127 +342 1 0.757472 4.19176 4.95128 10.4651 -6.09524 -1.36969 +343 1 0.907905 3.31127 5.7437 -27.4593 -10.6172 -1.55436 +344 1 0.042027 4.05791 5.75958 -12.212 5.31553 -4.25834 +345 1 1.73758 3.25237 5.02547 -7.72352 0.251809 -15.9993 +346 1 2.4871 4.0191 4.9543 -17.108 24.4302 2.09179 +347 1 2.45668 3.23081 5.78465 2.15315 9.79763 4.28788 +348 1 1.58106 4.05092 5.80356 25.1427 18.6418 -4.49313 +349 1 3.19249 3.31456 5.03239 24.0259 -22.2006 -10.8088 +350 1 4.20707 4.15779 4.866 -22.1265 -5.11578 15.6203 +351 1 4.10653 3.22389 5.85277 -11.4198 11.552 -29.8203 +352 1 3.32529 4.01575 5.8236 -9.29377 10.539 -6.33768 +353 1 5.02426 3.35158 5.01899 -31.0395 -2.45923 -24.1365 +354 1 5.68644 4.17189 4.85403 7.36649 -6.63658 10.5871 +355 1 5.74132 3.29275 5.69662 23.2126 4.63385 22.4488 +356 1 4.92531 4.19073 5.71088 -1.56015 -9.54037 12.8094 +357 1 6.54444 3.23385 4.93781 3.72392 28.1796 29.5331 +358 1 7.41233 4.02229 4.92924 -1.20364 12.0626 9.54412 +359 1 7.4663 3.28529 5.82942 -29.7597 -4.87929 -37.7444 +360 1 6.60644 4.05138 5.75927 -5.95188 5.2753 -7.63938 +361 1 8.20344 4.97671 5.0085 -9.77785 -27.0171 -16.098 +362 1 0.764125 5.65629 4.97235 19.2848 26.171 -13.514 +363 1 0.873777 4.9677 5.68286 -0.798932 -14.5746 27.2238 +364 1 8.1297 5.72693 5.67887 36.2224 14.0656 51.1647 +365 1 1.7318 5.02959 5.01529 -5.49043 -14.6131 -16.8314 +366 1 2.44542 5.85219 4.93063 19.3822 -11.3762 -19.1618 +367 1 2.55143 4.96012 5.6972 2.49476 -2.70049 4.14057 +368 1 1.7425 5.82205 5.68004 -17.6493 -28.263 45.9708 +369 1 3.3219 4.92271 4.83646 -0.36054 0.182371 1.57441 +370 1 4.15401 5.67616 4.9285 -21.3575 6.09757 11.4691 +371 1 4.07715 4.94174 5.74451 -0.595544 -7.12056 -1.40506 +372 1 3.31639 5.79418 5.70206 -6.4923 -7.4901 3.07645 +373 1 4.92581 4.94202 4.97984 -0.22012 5.90431 -14.5879 +374 1 5.73821 5.69855 4.88283 0.98112 8.81137 -0.251897 +375 1 5.70683 4.9474 5.70386 9.48927 0.653977 8.8924 +376 1 4.96412 5.79635 5.67508 -8.29845 -17.1654 19.2091 +377 1 6.48765 4.91573 4.91811 9.87445 -1.02048 -0.929801 +378 1 7.42803 5.76565 5.01887 -36.8924 9.29378 -39.8178 +379 1 7.31535 5.01349 5.75729 -2.96639 -15.6116 3.19898 +380 1 6.51112 5.80276 5.76292 -0.511839 0.0343249 -1.86567 +381 1 0.0752499 6.50198 4.93503 -9.95853 14.5519 3.18185 +382 1 0.749032 7.44313 4.93057 9.36322 -4.26106 -6.17112 +383 1 0.799308 6.59761 5.72007 7.23025 -2.947 1.48543 +384 1 0.0646916 7.47006 5.72188 -15.7332 -12.5303 9.25543 +385 1 1.64476 6.54961 5.03014 -20.9538 30.4927 -38.3434 +386 1 2.45435 7.39325 4.88002 3.42796 3.8663 5.03137 +387 1 2.4342 6.59097 5.67369 23.2905 17.249 22.0616 +388 1 1.54778 7.4679 5.8363 19.3115 -12.9738 -21.1698 +389 1 3.32159 6.57391 4.94635 0.920374 5.37222 -4.76541 +390 1 4.12734 7.43087 4.87631 0.0949958 -12.9619 14.1535 +391 1 4.03648 6.57336 5.82487 9.67898 -2.57585 -4.33725 +392 1 3.37401 7.44443 5.83215 -8.90767 -10.0262 -16.7558 +393 1 4.95785 6.5313 4.96795 -5.28369 20.3288 -12.6073 +394 1 5.72446 7.44815 4.95617 -0.295615 -4.81227 -6.28599 +395 1 5.67507 6.56368 5.75557 19.5363 2.36566 3.12879 +396 1 4.99604 7.36578 5.82253 -12.0795 7.56208 -16.0156 +397 1 6.47952 6.65183 4.84549 7.81673 -1.192 17.7565 +398 1 7.49045 7.38842 4.86267 -3.31154 -1.72952 10.3926 +399 1 7.31515 6.64393 5.7627 1.65473 -7.46902 -9.80451 +400 1 6.51213 7.44705 5.67942 6.88055 -5.46286 6.12471 +401 1 0.0806264 0.0886591 6.67061 2.86389 -53.8636 -44.0246 +402 1 0.883633 0.899989 6.55658 -11.6958 -11.9156 5.39561 +403 1 0.88757 0.0447352 7.4623 -6.5852 -8.63148 -1.54458 +404 1 0.00589996 0.782701 7.30583 -3.57511 51.2033 48.3924 +405 1 1.70878 0.0185969 6.53425 -9.91562 -0.171369 19.1044 +406 1 2.47179 0.820184 6.65916 -10.0875 0.778119 -25.3377 +407 1 2.53937 0.0160974 7.34796 -3.95783 -6.52463 5.98309 +408 1 1.62994 0.765044 7.35659 9.0133 10.535 7.11032 +409 1 3.30704 0.041501 6.48376 -12.5346 2.59741 23.4233 +410 1 4.02443 0.849646 6.63591 28.9911 -27.1685 -8.99322 +411 1 4.05271 0.0416361 7.37632 0.533135 -1.75778 -2.17869 +412 1 3.19386 0.898466 7.37702 15.4736 -11.3366 18.5812 +413 1 4.93306 0.0872445 6.49555 4.8751 -33.7979 36.6921 +414 1 5.84884 0.883258 6.55834 -5.60524 -28.829 17.1111 +415 1 5.81564 0.024621 7.40384 -2.36039 -5.56484 -6.47242 +416 1 4.961 0.816895 7.40894 -1.64345 1.03662 -2.05135 +417 1 6.67176 0.000709987 6.50931 -8.49107 -0.789231 11.0199 +418 1 7.42872 0.868407 6.55728 -5.95092 -10.3429 1.39671 +419 1 7.36138 8.18623 7.46478 9.04825 4.48366 -10.7424 +420 1 6.59985 0.825831 7.39669 4.88737 -2.34866 2.27965 +421 1 8.14416 1.67759 6.49013 32.825 -1.32457 17.7447 +422 1 0.9037 2.40379 6.60352 -22.6991 13.3728 -5.6252 +423 1 0.83815 1.6821 7.34463 -6.45777 -9.82884 14.5288 +424 1 8.19206 2.55987 7.48041 1.09967 -24.6646 -31.5822 +425 1 1.61029 1.6565 6.61062 19.3859 -4.50632 -8.40911 +426 1 2.39042 2.47779 6.49991 10.3869 -7.14038 20.8685 +427 1 2.43336 1.66264 7.31159 -0.298923 7.67874 9.60508 +428 1 1.68521 2.53757 7.43341 0.0908995 -20.3899 -19.4953 +429 1 3.34574 1.55658 6.57542 -29.1499 40.141 -5.99747 +430 1 4.09567 2.50385 6.58715 2.92988 -17.1157 8.90269 +431 1 4.06967 1.60141 7.36073 8.28003 9.68724 13.2999 +432 1 3.26291 2.44686 7.41755 -1.72761 -1.27824 0.484775 +433 1 5.02343 1.63061 6.57358 -10.9076 3.24904 2.06921 +434 1 5.8117 2.52535 6.48584 -2.10788 -3.23133 8.48842 +435 1 5.76381 1.64883 7.37339 7.06147 -0.584215 3.21917 +436 1 4.99697 2.44099 7.45915 -1.75923 11.2498 -19.4182 +437 1 6.62044 1.59458 6.63611 -5.65576 11.9066 -13.6974 +438 1 7.40085 2.40641 6.52565 -4.26631 17.0681 5.6259 +439 1 7.4086 1.68173 7.30269 7.67403 -2.22025 20.1658 +440 1 6.56414 2.4958 7.48155 2.02857 -0.65966 -9.40352 +441 1 8.16172 3.22 6.50779 31.0613 6.17733 37.0029 +442 1 0.778923 4.13348 6.47989 7.10682 -1.13444 17.3069 +443 1 0.731543 3.38344 7.32104 8.57141 -10.8353 -0.596329 +444 1 8.20703 4.11651 7.39737 -10.5501 6.3503 -2.89453 +445 1 1.5556 3.22612 6.62242 10.8567 18.3759 1.80723 +446 1 2.43596 4.07218 6.65191 19.5996 1.93234 -23.7547 +447 1 2.42128 3.38357 7.48855 6.46322 -13.7769 -4.42002 +448 1 1.70183 4.1306 7.3251 -28.6202 8.98318 18.3174 +449 1 3.23368 3.21004 6.55845 -1.66335 0.810928 5.98502 +450 1 4.02817 4.01745 6.59179 9.73332 14.3603 -1.234 +451 1 4.04024 3.24371 7.33596 9.19519 -2.61436 13.2612 +452 1 3.33578 4.03204 7.3761 -11.8519 11.1256 7.31388 +453 1 4.84615 3.34919 6.50516 30.474 -3.21025 16.5113 +454 1 5.79338 4.10407 6.63223 -1.4488 4.34379 -6.9657 +455 1 5.71769 3.33306 7.36343 3.56485 -8.31237 5.17357 +456 1 4.89884 4.06687 7.36632 1.94898 -1.38193 2.81677 +457 1 6.61297 3.34048 6.58436 -38.9416 -40.8203 -5.50523 +458 1 7.30794 4.01061 6.56591 40.2005 61.5018 -17.6954 +459 1 7.37741 3.36957 7.31145 38.0889 -52.6112 27.9446 +460 1 6.66665 4.01974 7.42717 -35.3166 42.1921 1.19147 +461 1 0.0452175 4.90338 6.62118 -6.71352 5.92623 -3.01906 +462 1 0.869367 5.66645 6.62279 -29.6122 19.3042 -24.6336 +463 1 0.858776 5.03104 7.45654 -16.814 -24.2615 8.51744 +464 1 8.14658 5.74936 7.4724 2.5583 -5.40279 -7.71149 +465 1 1.59957 4.95319 6.53572 14.873 -15.6204 -6.12191 +466 1 2.54529 5.66468 6.59785 -23.4011 43.3591 -27.461 +467 1 2.4961 5.03005 7.34302 -11.668 -32.1864 28.6337 +468 1 1.60544 5.69113 7.30132 37.8442 13.2739 23.8753 +469 1 3.24356 4.96073 6.59142 26.8133 -25.0989 -5.08933 +470 1 4.09781 5.67439 6.52285 2.63557 7.15813 7.05447 +471 1 4.18105 4.86276 7.35501 -9.07005 4.72655 -1.53462 +472 1 3.36767 5.65499 7.49749 6.09099 26.0319 -27.9028 +473 1 5.01795 4.94278 6.59504 -2.00637 0.995546 -1.6799 +474 1 5.7841 5.85399 6.63871 4.06216 -12.0086 -14.5693 +475 1 5.83404 5.02565 7.38856 -29.8707 -40.8918 -9.03319 +476 1 4.9605 5.83878 7.31445 -12.603 -27.5006 25.6094 +477 1 6.59477 4.88222 6.67554 -4.07568 1.88148 -17.9737 +478 1 7.35313 5.77701 6.52551 0.181186 3.4052 7.13046 +479 1 7.348 4.89641 7.37973 13.5892 1.99375 8.82978 +480 1 6.49663 5.74982 7.4422 46.6685 29.9241 -18.7201 +481 1 0.0491078 6.53098 6.47716 -5.83531 -0.141054 6.60445 +482 1 0.791488 7.40292 6.50563 -8.70546 -0.874788 22.49 +483 1 0.919931 6.51323 7.45776 -11.5314 25.4002 -28.1718 +484 1 0.0481113 7.40468 7.43229 -11.5944 -5.37754 -18.7674 +485 1 1.63473 6.52345 6.62888 -0.301482 5.86022 -13.1885 +486 1 2.54325 7.3746 6.52095 -7.01617 -1.6126 8.94816 +487 1 2.42821 6.65367 7.34715 -0.0947462 -6.49261 12.3075 +488 1 1.66344 7.43005 7.38619 -4.64698 1.83667 -2.7903 +489 1 3.21223 6.51896 6.65614 12.5802 -0.344258 -7.45446 +490 1 4.18524 7.3836 6.50889 -0.948752 5.15796 16.6381 +491 1 4.03479 6.58867 7.43482 10.4531 -7.07785 -21.0648 +492 1 3.31132 7.44815 7.43351 -1.0832 -4.66317 -4.42978 +493 1 5.00814 6.58691 6.66459 -15.2308 20.9466 -24.4589 +494 1 5.70889 7.39626 6.56563 14.4769 6.85637 10.1092 +495 1 5.73775 6.567 7.43094 6.72915 9.63092 8.95959 +496 1 4.91068 7.49261 7.37168 0.330155 -8.28614 -9.94049 +497 1 6.53726 6.65021 6.66417 -1.59265 -6.08794 -3.67401 +498 1 7.37246 7.29875 6.57444 7.56141 13.3939 8.59342 +499 1 7.35261 6.58373 7.49207 23.0737 -16.5957 -35.2353 +500 1 6.60589 7.39349 7.49219 -10.7096 3.92482 -19.5185 diff --git a/examples/mdi/dump.17Jun22.series.driver.mpi.1 b/examples/mdi/dump.17Jun22.series.driver.mpi.1 new file mode 100644 index 0000000000..847432833a --- /dev/null +++ b/examples/mdi/dump.17Jun22.series.driver.mpi.1 @@ -0,0 +1,1527 @@ +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +500 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 8.9390353509656766e+00 +0.0000000000000000e+00 8.9390353509656766e+00 +0.0000000000000000e+00 8.9390353509656766e+00 +ITEM: ATOMS id type x y z f_1[1] f_1[2] f_1[3] +1 1 0.0109462 8.91109 8.87705 -0.258023 0.625273 0.429284 +2 1 0.983178 0.93542 8.91066 -2.88593 0.281032 -1.95154 +3 1 0.886776 0.00353842 0.964105 -0.27179 0.383251 0.443719 +4 1 0.0722273 0.817966 0.815708 -0.663834 1.25489 -0.35451 +5 1 1.82919 8.8603 8.91164 0.346262 0.966337 0.327185 +6 1 2.71374 0.850558 0.0977971 -1.53533 0.952301 -0.539148 +7 1 2.75443 8.9152 0.943835 0.200679 -0.0265554 -0.862232 +8 1 1.72161 0.971413 0.796705 7.79754 -6.0811 1.58835 +9 1 3.47837 0.0294075 0.0515782 2.76325 -2.21894 -0.80311 +10 1 4.43186 0.961325 8.89919 -0.387918 -0.444884 0.950878 +11 1 4.37764 0.00631327 0.801109 0.844344 -0.87322 -0.116598 +12 1 3.59567 0.80748 0.974874 -0.705778 1.85625 -1.80855 +13 1 5.35026 8.89566 0.0208816 -0.442875 -0.272596 -0.473028 +14 1 6.3022 0.978028 0.0782288 -3.05518 -2.94099 -0.889505 +15 1 6.27707 0.0297536 0.962734 -0.0515917 0.772188 -1.05602 +16 1 5.30223 0.918655 0.899444 1.33545 0.759601 -1.29769 +17 1 7.0769 0.0948096 0.0649153 0.098645 -1.06535 0.292165 +18 1 8.09537 0.913626 0.0774105 -0.154847 0.414543 -0.451754 +19 1 8.08165 0.0818588 0.895196 -0.689773 -1.28143 0.929968 +20 1 7.14638 0.885276 0.891299 0.487793 0.733541 0.918445 +21 1 8.89456 1.84483 0.0434425 0.886905 -0.621358 -0.495646 +22 1 0.935681 2.64324 0.0406455 -1.34335 0.213362 -1.25695 +23 1 0.966071 1.69976 0.948945 -7.88058 11.3257 -7.25569 +24 1 0.0121607 2.66637 0.881115 -0.232812 0.533689 1.18415 +25 1 1.85044 1.81859 0.00192994 -1.7495 0.19048 0.1992 +26 1 2.68148 2.7251 0.0685109 -1.25528 -0.916148 -1.01459 +27 1 2.62716 1.70715 0.839166 0.688023 2.33788 1.05919 +28 1 1.6905 2.59418 0.903739 1.58905 0.257971 0.508129 +29 1 3.57454 1.77719 8.88663 0.186742 -0.0628404 0.80372 +30 1 4.38099 2.63699 8.92556 0.253897 0.0578989 -0.178058 +31 1 4.45919 1.78484 0.892793 0.372262 0.580252 -1.28381 +32 1 3.55804 2.657 0.821946 0.208194 0.440929 1.42052 +33 1 5.39579 1.85576 0.0513097 -2.11231 -0.770148 -0.833202 +34 1 6.28486 2.68552 0.0861957 -0.390024 -0.099671 -1.25573 +35 1 6.16167 1.79587 0.852166 3.13123 -0.282736 3.8241 +36 1 5.43841 2.67896 0.926914 -0.906522 -0.132525 -0.585389 +37 1 7.09214 1.72405 8.83985 3.26876 6.20695 4.03515 +38 1 7.96694 2.76043 0.0935037 2.29966 -0.680397 -1.28039 +39 1 8.06525 1.69772 0.940378 0.498274 0.445905 0.0355574 +40 1 7.16698 2.58338 0.88179 -1.8895 -0.0707859 1.12114 +41 1 0.0210451 3.48041 0.0428158 0.862491 -0.329006 -0.681709 +42 1 0.874431 4.40275 0.0131769 0.218928 -0.148848 0.324321 +43 1 0.851364 3.60752 0.914082 0.352487 -0.527665 -0.410754 +44 1 0.0749717 4.51844 0.974577 -0.257295 -0.287753 -0.288054 +45 1 1.76248 3.58626 0.0539576 0.480316 -2.29368 -1.63127 +46 1 2.72367 4.4241 0.0474256 0.0272964 0.241712 -0.452415 +47 1 2.73289 3.61199 0.901343 -0.0645249 -1.94992 -0.502421 +48 1 1.8456 4.38069 0.843492 -0.349918 1.31176 2.27682 +49 1 3.50387 3.55674 0.0315796 1.56114 -0.0224047 0.116984 +50 1 4.49692 4.37908 0.0780585 -4.54206 0.213106 -5.58215 +51 1 4.46671 3.57478 0.880458 -0.334204 -0.938728 0.874478 +52 1 3.58815 4.43 0.950374 0.652985 -1.92511 -1.59862 +53 1 5.3866 3.58372 8.92789 -1.19711 -2.22155 0.617325 +54 1 6.17276 4.37217 8.86047 6.00842 1.34471 4.78274 +55 1 6.27432 3.53871 0.907449 -0.148389 -0.137473 -0.523414 +56 1 5.27909 4.47835 0.809401 8.23917 -3.14067 4.34956 +57 1 7.09737 3.53698 8.87413 0.14026 -0.233191 0.941929 +58 1 7.96586 4.56922 8.84208 6.8748 -6.48505 1.75868 +59 1 8.1189 3.63425 0.96148 -3.00277 -1.46323 -4.15536 +60 1 7.14279 4.43222 0.962078 -0.0459577 0.247999 0.321752 +61 1 8.89637 5.43177 8.92691 0.327116 0.812268 0.0679643 +62 1 0.854018 6.30348 0.0813318 1.06274 -7.24911 -7.87042 +63 1 0.873415 5.41923 0.812761 -0.31071 -0.409433 0.423823 +64 1 8.88236 6.35419 0.863575 -0.753758 -3.06962 -0.690381 +65 1 1.76334 5.40934 8.88249 1.8326 1.29836 1.91996 +66 1 2.68777 6.21767 8.90577 0.0461489 1.51967 -0.262666 +67 1 2.66088 5.41906 0.821357 0.262109 -0.890774 -0.241847 +68 1 1.86017 6.31332 0.804602 -1.38053 -1.13952 0.850174 +69 1 3.64435 5.42051 8.90358 -2.6101 -2.17442 -0.370474 +70 1 4.37466 6.25131 8.85278 3.71832 2.70453 0.946098 +71 1 4.53047 5.2708 0.824393 -3.54051 3.8431 0.931364 +72 1 3.61222 6.27635 0.96909 -4.05414 0.604922 -3.58471 +73 1 5.40042 5.34751 8.8935 -0.719369 -0.36085 0.212296 +74 1 6.18215 6.3156 0.0196993 0.267387 0.110688 0.223648 +75 1 6.27516 5.37868 0.90209 -1.0642 -0.241069 0.481931 +76 1 5.31268 6.25584 0.875522 0.133781 0.115172 0.026661 +77 1 7.20113 5.30633 8.84474 -4.87308 6.78349 0.0391413 +78 1 7.95512 6.30497 0.092705 6.00614 -6.0265 -0.649957 +79 1 8.08767 5.35538 0.811364 -1.15126 0.392579 0.741715 +80 1 7.08607 6.1919 0.926051 0.630581 3.46407 -2.46157 +81 1 8.92405 7.0566 8.88782 -1.53371 0.564813 -0.0213323 +82 1 0.905011 8.13513 0.0600006 -0.504969 -0.194195 -0.00181653 +83 1 0.816253 7.07033 0.801556 1.36958 7.74762 7.34595 +84 1 8.83925 8.07727 0.907684 2.46931 1.67506 1.17354 +85 1 1.86043 7.09328 8.91972 -0.773441 0.857837 1.39948 +86 1 2.76541 7.99166 0.0440794 -0.77809 1.05822 0.425741 +87 1 2.67654 7.18636 0.91183 2.62219 -2.00002 -0.219028 +88 1 1.8788 7.9677 0.915621 -0.894934 2.07357 -1.21117 +89 1 3.59357 7.13026 0.0332195 -0.388167 0.00237965 -0.544686 +90 1 4.38663 8.07233 8.88382 0.174711 -0.440379 0.0897133 +91 1 4.5359 7.22854 0.936578 -2.37627 -1.04519 -2.35662 +92 1 3.63538 7.97981 0.824881 -1.61206 1.29888 2.0997 +93 1 5.3271 7.23059 8.92328 -0.111431 -0.20975 0.289951 +94 1 6.30867 8.05581 8.84577 0.0946421 0.0525728 2.57365 +95 1 6.32003 7.15576 0.891457 -0.2569 -0.483959 0.0547371 +96 1 5.40661 7.9868 0.968462 0.415884 0.0845497 -0.268424 +97 1 7.22798 7.08713 0.0563741 -5.45853 5.72078 -0.51002 +98 1 8.05735 8.06186 0.0753342 -0.611004 1.73052 -2.95918 +99 1 8.10922 7.21906 0.806609 -0.400473 -2.4357 2.42821 +100 1 7.16998 8.08498 0.846622 0.253892 0.388538 0.000271703 +101 1 8.88419 0.00785958 1.88382 0.148531 -0.55276 -3.06718 +102 1 0.806706 0.963107 1.6981 0.146821 -6.1479 7.24676 +103 1 0.81371 8.93107 2.59291 1.58623 0.25767 2.66866 +104 1 0.0914118 0.851308 2.7806 -2.96193 1.34432 -3.85013 +105 1 1.70908 0.055279 1.86232 -0.26684 0.0875329 -0.306957 +106 1 2.72497 0.940903 1.70203 -0.757536 -0.918748 1.71384 +107 1 2.71129 0.0639965 2.67102 -0.311468 0.261861 0.646041 +108 1 1.73889 0.96912 2.64369 0.123913 0.173982 0.666446 +109 1 3.52533 0.0194588 1.83263 1.01391 -0.00454228 -0.284845 +110 1 4.50633 0.992013 1.70842 -3.51938 -2.99082 2.23564 +111 1 4.49463 8.9275 2.60712 -6.23135 -0.421499 6.59704 +112 1 3.51061 0.932206 2.63613 0.265327 0.172351 0.555119 +113 1 5.26459 0.0845656 1.88118 6.41483 1.44516 -5.35427 +114 1 6.26822 0.943133 1.78953 -0.172034 -0.0988047 -0.238973 +115 1 6.20352 0.0931252 2.63772 -0.251863 0.451194 0.97073 +116 1 5.33497 0.961022 2.74861 1.85573 -2.10168 -0.655218 +117 1 7.15143 8.91799 1.69931 0.631991 0.791476 -0.168042 +118 1 8.1075 0.884637 1.85069 -0.145764 0.238097 -0.736312 +119 1 8.10277 0.00424992 2.71008 -1.61591 0.00687295 -1.36275 +120 1 7.06485 0.985537 2.76239 8.19773 -7.92397 -1.18231 +121 1 8.91698 1.83538 1.78872 0.656642 -0.0731624 0.0431027 +122 1 0.901335 2.58954 1.84197 -0.375827 -0.324571 -2.7055 +123 1 0.839546 1.79651 2.68072 1.09251 -0.901613 -0.242728 +124 1 0.0205195 2.75315 2.62687 -0.478759 -0.0106512 -0.67727 +125 1 1.78258 1.70562 1.69835 1.31189 0.545066 2.20675 +126 1 2.77409 2.6552 1.77928 -3.71202 0.456863 -3.25075 +127 1 2.62583 1.79361 2.77487 3.4762 0.328618 -3.48584 +128 1 1.71155 2.69761 2.62919 0.862289 -1.38539 2.38335 +129 1 3.5477 1.79572 1.86096 1.43061 -0.605958 -0.978191 +130 1 4.46749 2.5924 1.76238 -0.0494618 -0.0821277 -0.176353 +131 1 4.52929 1.74324 2.59829 -2.00749 0.662049 0.061349 +132 1 3.48188 2.69682 2.61959 1.88694 -0.141301 3.78311 +133 1 5.34711 1.71486 1.76809 1.96327 2.17405 -0.830705 +134 1 6.24637 2.73306 1.80484 3.10489 -2.12999 -0.788559 +135 1 6.31443 1.71423 2.71392 -8.21546 8.18972 -0.602972 +136 1 5.26572 2.69815 2.75971 0.0267628 0.10355 -0.216257 +137 1 7.18953 1.75159 1.71849 -0.576203 -0.36263 1.38792 +138 1 8.05027 2.77408 1.76451 0.439173 -0.587966 -0.341117 +139 1 8.01591 1.69661 2.74434 0.366947 0.0491547 0.134545 +140 1 7.14772 2.69371 2.58907 0.0738449 -1.92773 2.13155 +141 1 8.86781 3.66165 1.74517 3.90719 -1.47472 3.87657 +142 1 0.936621 4.42773 1.79512 -0.401045 -0.147867 0.321366 +143 1 0.948846 3.59531 2.72105 -0.571635 -0.0105131 -1.06193 +144 1 0.0834486 4.38982 2.63588 -0.524533 1.06652 0.75481 +145 1 1.83432 3.4799 1.75691 0.359017 0.665628 -0.818381 +146 1 2.69175 4.37077 1.75144 0.14004 0.214725 0.925417 +147 1 2.74153 3.6404 2.67912 -0.708299 -3.83642 -3.24565 +148 1 1.87968 4.54846 2.67269 -0.684796 -0.993828 -0.138535 +149 1 3.5441 3.51573 1.77434 0.186245 0.881611 -0.696526 +150 1 4.55171 4.52396 1.79145 -2.75839 -2.91024 -1.57263 +151 1 4.49896 3.65335 2.59498 -1.96388 -1.7196 0.869652 +152 1 3.49741 4.47737 2.77344 8.37692 1.8085 -7.7175 +153 1 5.44145 3.48872 1.74764 -3.05421 3.82286 1.14399 +154 1 6.1743 4.53053 1.74574 0.463366 -1.70291 0.122224 +155 1 6.30198 3.67131 2.70975 -1.07292 -0.185523 -2.51985 +156 1 5.34196 4.38653 2.7007 1.29125 2.52938 -0.102964 +157 1 7.1691 3.54339 1.87445 -0.749456 2.7751 -2.56091 +158 1 7.97266 4.40051 1.79603 0.56071 1.27489 1.72891 +159 1 7.99234 3.49992 2.67525 0.940044 2.40885 0.128516 +160 1 7.18063 4.50303 2.68825 -0.923025 -2.40154 0.0954191 +161 1 8.91159 5.33038 1.82507 -0.0203349 -0.241672 0.333237 +162 1 0.8958 6.32359 1.78851 0.38501 -0.14702 -0.347965 +163 1 0.943571 5.31749 2.71754 -0.318578 -0.34148 0.397124 +164 1 0.0864418 6.28418 2.68726 -1.86154 0.137969 -3.27119 +165 1 1.71465 5.37463 1.6949 -0.232891 -0.268012 0.301526 +166 1 2.72852 6.31988 1.88644 -2.78715 -2.37305 -5.95735 +167 1 2.64735 5.41101 2.73193 1.7471 0.192556 0.973026 +168 1 1.84919 6.27948 2.72157 -0.39498 0.808971 -0.0974847 +169 1 3.48336 5.2657 1.71665 0.625214 2.24561 1.33995 +170 1 4.39296 6.19435 1.72952 3.81534 -0.586193 2.86006 +171 1 4.52517 5.37564 2.62027 -1.99502 -0.45422 2.59567 +172 1 3.56333 6.24537 2.5877 2.83084 0.938216 3.4987 +173 1 5.32581 5.29562 1.86847 5.13697 3.80601 -2.04537 +174 1 6.24758 6.22298 1.79203 0.477004 0.378689 0.56244 +175 1 6.25283 5.44934 2.73731 1.14422 -0.830366 -0.337224 +176 1 5.45416 6.25624 2.6996 -2.42774 -1.74418 -0.22606 +177 1 7.22676 5.41803 1.71412 0.223451 -2.28899 2.0191 +178 1 8.0979 6.3518 1.78861 -0.44204 -0.435572 -0.338725 +179 1 8.01325 5.26918 2.64973 1.18264 0.878361 -0.124926 +180 1 7.11991 6.34415 2.69936 -1.3293 -2.66755 2.78128 +181 1 0.0635545 7.11209 1.72165 -0.371894 2.049 0.790012 +182 1 0.857409 8.07873 1.82753 -0.608672 -0.60495 -0.46291 +183 1 0.930573 7.24697 2.65225 -4.55248 -4.69883 0.513873 +184 1 8.8491 7.95414 2.58819 0.570786 1.09764 -0.00497061 +185 1 1.71811 7.19809 1.77835 0.893245 -0.692356 0.118249 +186 1 2.78024 8.04523 1.70672 -2.88976 2.48107 0.040135 +187 1 2.67012 7.13476 2.61708 -1.16009 2.6938 3.43626 +188 1 1.72659 7.99584 2.64342 2.19305 3.0992 -0.0129086 +189 1 3.48631 7.23394 1.84989 5.35093 -4.92393 -2.00054 +190 1 4.4261 8.04744 1.77118 -0.338387 -0.0128497 0.448007 +191 1 4.41287 7.13619 2.73708 2.81119 1.17101 -3.79683 +192 1 3.52255 7.96143 2.73527 1.04353 0.896155 0.0445218 +193 1 5.31509 7.09458 1.73703 1.75862 -0.357986 2.37379 +194 1 6.31592 8.04277 1.87992 0.07968 -0.344084 0.021952 +195 1 6.19476 7.08883 2.7194 5.13464 2.37882 -2.53303 +196 1 5.31616 7.97076 2.64032 0.139732 0.0575338 -0.0995313 +197 1 7.13779 7.0901 1.87785 -0.856279 1.84142 -1.45962 +198 1 8.00182 8.12007 1.73344 0.812689 0.333431 -0.248462 +199 1 8.01591 7.08327 2.73264 -0.0756439 0.769292 0.331432 +200 1 7.15074 8.00152 2.76416 1.82643 0.942676 -3.56152 +201 1 8.89655 8.9304 3.48678 1.65951 -0.447815 3.8493 +202 1 0.950495 0.819015 3.5162 -1.29532 1.69106 1.16913 +203 1 0.81801 0.0539921 4.51501 3.2278 -0.258036 -5.15445 +204 1 8.85177 0.90744 4.37372 14 -2.90794 10.8129 +205 1 1.78019 0.0426842 3.56938 1.84169 -0.836001 -0.350651 +206 1 2.63146 0.926366 3.57031 0.012479 0.082004 0.331715 +207 1 2.70742 0.0633514 4.41591 -1.37547 -1.33331 0.456319 +208 1 1.7142 0.801654 4.43761 0.662356 1.10176 0.272549 +209 1 3.65397 8.84382 3.54877 -3.56671 5.39916 0.463391 +210 1 4.3911 0.894602 3.52171 0.595814 -0.346452 0.321605 +211 1 4.50401 0.046887 4.49909 -1.14502 -0.949582 -0.274225 +212 1 3.51809 0.843433 4.41351 1.90854 2.37085 -0.229306 +213 1 5.34066 0.0102546 3.52427 -0.108558 0.828678 0.2339 +214 1 6.2908 0.991162 3.59141 -5.23018 -9.53106 -1.9323 +215 1 6.23033 0.0280237 4.46344 1.30838 0.516693 -1.50043 +216 1 5.29132 0.919899 4.38256 0.973507 -2.91573 1.14051 +217 1 7.06389 8.92307 3.63529 1.41369 0.894395 -0.0234904 +218 1 8.13244 0.926287 3.63848 -11.0259 -0.689673 -11.6462 +219 1 8.07431 0.0396355 4.42295 -0.0998371 -0.343464 -0.2111 +220 1 7.15426 0.902415 4.51611 0.37609 -0.87238 -0.174942 +221 1 0.0547819 1.70767 3.52402 -0.0990054 0.634623 1.9504 +222 1 0.990251 2.59589 3.64321 -1.70133 -1.15531 -1.34459 +223 1 0.876254 1.75025 4.46545 0.108846 -0.46015 0.445192 +224 1 8.851 2.6248 4.52232 3.89545 -0.330965 -5.02573 +225 1 1.83233 1.81735 3.53725 -2.40083 -0.602726 2.24699 +226 1 2.73685 2.66072 3.63237 -1.34367 -0.0545412 -0.555358 +227 1 2.76889 1.75912 4.53924 -5.46261 0.887424 -6.31803 +228 1 1.79935 2.60963 4.48075 0.43952 -0.293553 0.768966 +229 1 3.51296 1.81737 3.56522 0.159577 -1.35984 0.863711 +230 1 4.48313 2.73941 3.65804 -0.990489 -8.98093 -5.87222 +231 1 4.37894 1.70897 4.40451 -1.1595 -0.0369555 -0.272198 +232 1 3.5578 2.69572 4.44594 -0.0317478 -0.740538 0.514717 +233 1 5.41644 1.73157 3.63972 -0.214907 2.94643 -2.78853 +234 1 6.22995 2.60145 3.56616 -0.0106554 -0.60109 0.383738 +235 1 6.30303 1.6885 4.42264 -3.32083 3.037 6.44969 +236 1 5.43404 2.73282 4.52181 -0.69148 0.715375 -0.475461 +237 1 7.08666 1.7162 3.65955 7.29974 4.17951 -2.48105 +238 1 8.0318 2.68816 3.49666 -0.181832 0.425298 0.461358 +239 1 8.08432 1.70749 4.5149 -2.31295 1.75558 0.820722 +240 1 7.18431 2.71452 4.51289 0.136997 -0.067144 0.521486 +241 1 8.84691 3.61245 3.64188 4.42683 -0.879675 -3.24184 +242 1 0.916797 4.43325 3.62545 -0.842258 -0.010797 0.0107287 +243 1 0.871748 3.60004 4.51194 -0.301498 0.107107 -0.324598 +244 1 8.92426 4.51452 4.44006 -0.00859866 -1.77564 -0.547037 +245 1 1.68965 3.48331 3.5995 1.50205 1.26015 1.14935 +246 1 2.74619 4.38356 3.49878 -7.16717 1.90489 10.07 +247 1 2.74519 3.65012 4.52097 -2.02388 -3.55766 -1.13857 +248 1 1.75432 4.38414 4.53252 -0.421779 0.409337 0.409015 +249 1 3.58997 3.49254 3.52387 -0.821723 1.10659 0.0739307 +250 1 4.40569 4.52296 3.53187 0.545495 -0.966363 -0.0502063 +251 1 4.38156 3.4874 4.39271 -0.289264 8.2647 7.79533 +252 1 3.54333 4.42257 4.55563 2.80723 11.1106 -9.83606 +253 1 5.27331 3.5295 3.65482 2.61308 2.66186 -0.969787 +254 1 6.16108 4.46828 3.59956 0.599894 -1.41883 -0.240371 +255 1 6.22639 3.63251 4.44985 -0.305031 -0.480252 0.0742084 +256 1 5.31568 4.40222 4.46767 -0.344747 -0.443719 0.00587924 +257 1 7.10015 3.56367 3.49443 2.55034 0.169304 1.35525 +258 1 8.02171 4.37546 3.5697 -1.76106 3.37709 -2.28074 +259 1 8.069 3.64942 4.40708 -2.31714 -3.33053 6.18677 +260 1 7.18438 4.37135 4.52245 -1.79563 0.274401 -0.392524 +261 1 0.0758128 5.3487 3.5652 0.184463 -0.360483 0.192319 +262 1 0.795174 6.30898 3.53894 9.14413 -6.75396 2.48214 +263 1 0.867482 5.30202 4.453 0.791187 0.0370161 0.388706 +264 1 0.00225224 6.31064 4.52093 0.402626 -0.0990512 0.0415993 +265 1 1.75224 5.26394 3.64332 0.696547 0.221295 -0.114908 +266 1 2.74065 6.24856 3.64631 -0.500385 1.40459 -1.64071 +267 1 2.73855 5.4528 4.44688 -5.40773 -5.67129 2.9343 +268 1 1.74472 6.17623 4.53641 0.82995 0.717951 -0.0718944 +269 1 3.48421 5.34442 3.61728 1.66736 -1.06074 -1.09811 +270 1 4.41383 6.35055 3.60638 9.51906 -9.2799 1.43724 +271 1 4.38632 5.26464 4.48258 -0.919101 0.504742 0.900072 +272 1 3.55793 6.1617 4.49469 4.34711 2.82736 -0.340092 +273 1 5.36863 5.28325 3.49178 -0.734818 0.617922 -0.744768 +274 1 6.26503 6.19943 3.66319 0.429882 1.55809 -2.03015 +275 1 6.35487 5.3413 4.44757 0.561767 -0.978785 -0.133344 +276 1 5.27408 6.24166 4.56754 6.98603 1.54355 -5.42942 +277 1 7.19701 5.44828 3.47564 -5.73363 -4.54905 0.0826653 +278 1 7.95668 6.19688 3.55501 6.31824 5.03885 -1.22951 +279 1 8.09251 5.32103 4.3972 -0.525971 0.388914 -0.470954 +280 1 7.21521 6.34275 4.38759 -5.30552 -2.8442 0.851377 +281 1 0.0775826 7.08234 3.53581 -5.46769 7.72822 0.0708503 +282 1 0.933572 7.95134 3.59844 -0.0755868 -0.81045 -0.0294233 +283 1 0.967321 7.07254 4.42487 -1.68738 -0.0136546 1.81969 +284 1 8.87247 7.95576 4.3937 0.743652 0.272325 -0.92866 +285 1 1.76917 7.11669 3.64005 0.930468 -0.723585 -1.50003 +286 1 2.76456 8.10499 3.62233 -0.317456 0.121935 0.766743 +287 1 2.61456 7.10311 4.56718 0.759736 -0.536182 -1.28605 +288 1 1.85332 7.96709 4.49102 -0.903085 0.0612931 0.171005 +289 1 3.6668 7.06536 3.52857 -12.7314 9.15268 1.72289 +290 1 4.37522 8.04334 3.61636 3.8155 -4.43194 -0.0509001 +291 1 4.53661 7.19684 4.42303 -0.089737 0.0836956 0.326132 +292 1 3.62847 8.06443 4.56174 -6.53673 1.14979 -7.53287 +293 1 5.44626 7.09379 3.53396 -2.70855 0.0837127 2.61511 +294 1 6.30058 8.08668 3.48692 -3.50797 -0.210369 1.40313 +295 1 6.24642 7.05504 4.56658 1.23504 0.486666 -1.51311 +296 1 5.40389 8.14153 4.41484 -1.1149 -1.90428 -2.07503 +297 1 7.0793 7.23572 3.56625 0.390898 -5.13728 0.366365 +298 1 8.02564 8.11993 3.55841 -0.989908 -0.0289504 0.0817166 +299 1 7.96341 7.11444 4.5691 3.18586 3.20848 -0.902141 +300 1 7.14662 7.9965 4.39373 -0.0363915 0.663241 1.28885 +301 1 0.0665117 0.0620058 5.29566 -4.76408 0.0634028 3.8487 +302 1 0.920378 0.847838 5.33345 0.704711 1.73157 1.07432 +303 1 0.90733 0.0507073 6.29492 -0.256865 0.383558 -0.568888 +304 1 0.0695806 0.935871 6.21245 0.520609 -0.18085 0.460935 +305 1 1.7158 8.90069 5.2688 0.480844 0.845699 -0.0820744 +306 1 2.72956 0.862321 5.35582 -0.666933 0.680843 -0.243728 +307 1 2.75788 8.89573 6.26927 0.729554 0.867268 -0.717865 +308 1 1.87787 0.918127 6.17945 -0.463015 -0.230718 0.375845 +309 1 3.57292 0.0827463 5.28099 -0.282881 -3.17985 0.660183 +310 1 4.39889 0.831174 5.46088 -0.653335 9.17872 -7.1909 +311 1 4.53367 0.077487 6.1821 0.157227 -8.03625 7.38236 +312 1 3.56635 0.935389 6.31146 0.221361 0.0036999 -1.2625 +313 1 5.44773 8.84526 5.27719 -1.51548 1.46139 3.00719 +314 1 6.272 0.802404 5.33609 -0.667532 1.91594 -0.251293 +315 1 6.22537 8.89219 6.16591 -0.245349 -0.895062 1.43446 +316 1 5.33827 0.94153 6.32303 -1.13614 0.583964 -0.338203 +317 1 7.11863 0.0577427 5.44516 0.0248025 -1.55594 -0.512164 +318 1 7.97781 0.796351 5.39903 0.844611 2.54625 -2.84321 +319 1 8.06017 8.92765 6.18069 -0.104306 -2.31947 1.77241 +320 1 7.18164 0.989783 6.31023 -0.163547 -0.192109 -0.79717 +321 1 0.0916103 1.88258 5.39516 -1.00186 -1.43206 -0.661702 +322 1 0.982314 2.60245 5.42151 0.964023 2.57135 -1.73713 +323 1 0.897632 1.84422 6.25233 0.598171 -0.657266 0.69786 +324 1 0.0925235 2.7239 6.16577 -1.60764 0.211114 1.61705 +325 1 1.82959 1.77578 5.39133 -0.293694 0.755656 -0.589776 +326 1 2.69272 2.74727 5.44011 1.7292 -2.84836 -1.30998 +327 1 2.6889 1.83234 6.17525 0.647659 -0.90616 0.231454 +328 1 1.77521 2.70825 6.28078 0.536701 -0.406727 0.0293567 +329 1 3.51954 1.69427 5.29216 6.69261 0.0739574 6.33581 +330 1 4.4097 2.73314 5.34432 0.344675 0.135757 -0.187596 +331 1 4.40444 1.82369 6.16689 4.836 -4.97823 0.364517 +332 1 3.67178 2.60038 6.25743 -5.49724 5.54416 -0.00203516 +333 1 5.35146 1.77827 5.39473 -0.235283 0.213892 0.835574 +334 1 6.28399 2.77802 5.42862 -0.340126 -0.250486 -0.411738 +335 1 6.23134 1.81375 6.22687 0.0223138 0.244736 0.523936 +336 1 5.32351 2.70513 6.28288 3.08354 -1.69468 -3.77436 +337 1 7.14617 1.80036 5.35567 0.0919136 -0.311209 -0.475968 +338 1 8.0974 2.70612 5.29285 -7.26474 -2.41437 5.10983 +339 1 8.1011 1.88391 6.31294 0.0553936 -2.83177 -2.84321 +340 1 7.18351 2.67214 6.17899 0.615225 -0.197791 1.28477 +341 1 8.87232 3.47935 5.28683 2.9021 4.26792 0.541835 +342 1 0.935261 4.37233 5.44726 0.629241 0.918492 -0.917538 +343 1 0.919878 3.52494 6.23281 0.869805 0.127506 1.01894 +344 1 0.00431382 4.37186 6.33532 0.0302966 1.00444 -0.578346 +345 1 1.87251 3.50381 5.42034 -2.4415 2.77086 0.0779929 +346 1 2.70362 4.48406 5.3041 -1.90814 0.882252 2.42793 +347 1 2.75055 3.50273 6.30756 -1.47013 1.25632 -0.795276 +348 1 1.84448 4.4497 6.22456 -0.665656 -0.501499 -0.145372 +349 1 3.61741 3.6732 5.27884 1.4909 -8.59965 8.97662 +350 1 4.55362 4.53069 5.43699 -1.55164 -1.28771 -1.47171 +351 1 4.52256 3.52483 6.1944 -1.86903 1.10409 1.578 +352 1 3.65361 4.51782 6.21866 -3.39722 -3.70857 0.481797 +353 1 5.32088 3.65892 5.41856 2.55855 -1.45769 -1.45685 +354 1 6.25422 4.4123 5.33119 0.406295 0.346858 0.292537 +355 1 6.15978 3.47786 6.34128 0.227911 3.77427 -2.75081 +356 1 5.33342 4.43001 6.30433 -0.582231 -0.0994195 -0.382533 +357 1 7.19473 3.56016 5.44441 -0.898652 0.294925 -2.64663 +358 1 7.98682 4.41046 5.33513 1.4916 0.0945815 1.20731 +359 1 7.97947 3.58929 6.2697 1.92008 -1.0462 0.640867 +360 1 7.19164 4.45465 6.22659 0.298273 0.832684 -0.26134 +361 1 8.91866 5.33922 5.43231 0.972904 -0.678404 -1.89043 +362 1 0.863832 6.24178 5.44793 2.40494 -1.34388 -3.01765 +363 1 0.840212 5.37684 6.26703 1.52144 -3.32025 -2.26664 +364 1 0.0375152 6.17563 6.19921 -3.52547 2.50803 1.96141 +365 1 1.71406 5.31325 5.33193 0.359992 -0.20317 1.05182 +366 1 2.70446 6.22369 5.28953 -1.67496 -0.128385 2.17513 +367 1 2.62094 5.31478 6.20919 0.620292 0.0770975 0.0647467 +368 1 1.78318 6.16446 6.20286 -0.707464 0.30734 -0.850222 +369 1 3.5001 5.34304 5.42111 1.18155 0.33408 -1.88423 +370 1 4.48409 6.21311 5.27474 -6.47906 -0.498054 6.10955 +371 1 4.40434 5.30746 6.24861 3.30032 4.47126 1.95885 +372 1 3.65651 6.23636 6.35732 0.258101 -0.821502 -0.539452 +373 1 5.37686 5.39062 5.45706 -0.495794 0.303868 0.87367 +374 1 6.27665 6.3275 5.44876 0.578726 -4.19567 -0.915026 +375 1 6.28987 5.34918 6.28481 -0.689441 0.646514 -0.025026 +376 1 5.38856 6.30438 6.29204 -0.62461 -0.174266 -0.144794 +377 1 7.10303 5.36134 5.39788 0.303084 -0.453051 0.575398 +378 1 7.97278 6.2689 5.34555 1.29349 -0.0892034 0.239307 +379 1 8.1123 5.2681 6.25774 -0.648694 -0.661016 0.761589 +380 1 7.23419 6.34793 6.22344 -1.98134 -0.75315 1.10815 +381 1 0.0530217 7.08624 5.43675 -2.76329 0.356415 -1.34254 +382 1 0.891502 8.07734 5.33574 -0.449954 -0.433341 -0.0145848 +383 1 0.859902 7.08778 6.21702 1.22817 0.316603 2.39974 +384 1 8.86723 7.96664 6.28254 0.557062 3.16551 -3.15026 +385 1 1.77928 7.05564 5.34292 -1.2854 -0.797113 0.726349 +386 1 2.74792 8.05162 5.34603 0.580474 -0.247926 -0.00393627 +387 1 2.61984 7.13654 6.2076 0.1179 0.00397349 -0.327299 +388 1 1.73531 7.99204 6.32624 -0.619957 1.84241 -1.57732 +389 1 3.59984 7.17613 5.43634 -0.452415 0.706682 -0.14784 +390 1 4.39821 8.05962 5.28157 7.32724 0.749963 7.12774 +391 1 4.53389 7.20586 6.21186 -1.71384 -1.49003 0.809357 +392 1 3.66572 8.09269 6.23368 0.381787 -1.59697 -1.53597 +393 1 5.43811 7.11751 5.40192 -5.5589 -0.00418968 -4.06356 +394 1 6.35445 7.96959 5.31467 -2.59984 2.44569 0.360222 +395 1 6.17375 7.13942 6.18142 5.31103 3.8936 7.8957 +396 1 5.29125 8.02549 6.29493 1.99742 1.43167 0.441829 +397 1 7.11664 7.15874 5.38774 1.63444 -2.12611 -0.430051 +398 1 8.12983 8.0005 5.26693 -0.350623 0.791023 2.07438 +399 1 8.11089 7.10521 6.29529 -1.02761 -0.414645 -0.639575 +400 1 7.1542 8.04467 6.33119 -0.716395 -2.97685 -2.97233 +401 1 0.0455321 0.0581059 7.13785 -2.59331 -3.08955 0.589456 +402 1 0.853998 0.797568 7.23372 2.25232 12.9399 -9.25923 +403 1 0.893883 0.0531987 7.95582 -0.265032 -9.78891 10.4341 +404 1 0.0979374 0.927475 8.08374 -1.27945 -0.625441 0.909779 +405 1 1.70883 0.0184568 7.15475 0.947479 -0.211015 -0.0644084 +406 1 2.65212 0.910749 7.07723 -0.301347 -0.213339 -0.337826 +407 1 2.6305 8.90469 8.0727 2.55272 1.71066 0.384582 +408 1 1.75018 0.91387 8.02574 -0.526684 -0.686186 -0.483147 +409 1 3.61403 8.84934 7.06612 1.02988 1.44024 1.76178 +410 1 4.42034 0.91943 7.17223 0.522178 -1.61468 -2.10925 +411 1 4.37056 0.0516865 8.14003 0.0263315 0.189467 -0.466418 +412 1 3.59 0.934896 8.00045 0.0371044 1.00787 1.05016 +413 1 5.2816 0.0108877 7.14004 0.0410715 -0.366939 -0.311788 +414 1 6.23624 0.898837 7.05965 1.021 0.941131 0.654753 +415 1 6.246 8.87468 8.06175 -0.280098 0.535663 -1.1759 +416 1 5.31648 0.815501 8.12607 -0.78801 0.243527 -0.599256 +417 1 7.10707 8.84874 7.08197 -0.468775 2.08644 1.86713 +418 1 8.05013 0.946529 7.22788 -1.5208 -0.582053 0.186559 +419 1 8.1301 8.84043 8.01457 0.052244 0.715074 -0.282442 +420 1 7.06838 0.987221 8.03414 10.0415 -13.6791 -1.19755 +421 1 8.86835 1.70934 7.22731 2.54892 2.22649 -0.22541 +422 1 0.866325 2.76414 7.15029 -0.0137847 -2.49225 -3.8584 +423 1 0.826708 1.83336 8.03111 1.70357 -1.53255 0.309164 +424 1 0.0511912 2.65175 8.02861 -1.53037 1.53618 -0.152554 +425 1 1.7237 1.71044 7.1133 -0.3904 -0.435435 -0.731182 +426 1 2.66636 2.72018 7.14295 0.547793 -0.274295 0.648117 +427 1 2.70105 1.80209 8.13576 -0.0852062 -0.133841 -0.000493208 +428 1 1.77492 2.76081 8.10399 0.564357 -0.308093 0.985398 +429 1 3.66205 1.87543 7.16799 0.15905 -2.5091 -2.55207 +430 1 4.55348 2.70177 7.05301 -5.50098 -2.53366 3.01389 +431 1 4.46818 1.71608 7.96441 0.32513 1.80226 3.00161 +432 1 3.56091 2.58808 8.02945 0.396266 1.95642 2.12785 +433 1 5.36149 1.84637 7.16969 0.516803 -0.0610583 -0.802699 +434 1 6.28291 2.77184 7.1854 -0.512674 -3.17359 2.22694 +435 1 6.3427 1.71551 7.9726 -15.2061 11.4078 1.6664 +436 1 5.45463 2.61593 8.09933 0.73198 1.12429 -0.810915 +437 1 7.14617 1.80598 7.24022 4.03182 0.503759 -4.81039 +438 1 8.07521 2.6756 7.07092 -0.336894 3.22322 3.478 +439 1 8.11875 1.8373 8.10797 -1.57974 -0.493075 -0.537868 +440 1 7.09714 2.63714 8.02739 -0.0173147 0.820696 1.90431 +441 1 8.85027 3.56499 7.15253 3.00565 -1.27064 -0.682205 +442 1 0.885235 4.38222 7.18774 -1.842 1.22146 -0.226395 +443 1 0.884771 3.48141 7.97536 -0.530218 4.3971 3.23625 +444 1 0.0419078 4.41462 8.04436 -0.806344 -0.262731 -0.956831 +445 1 1.73746 3.66699 7.09267 1.85773 -3.96877 -1.41987 +446 1 2.66489 4.55163 7.19564 0.399017 -1.47837 -0.325749 +447 1 2.68401 3.61278 8.06372 0.262338 -0.0680464 0.329915 +448 1 1.80878 4.38262 7.9551 -1.46544 1.49945 2.09645 +449 1 3.55441 3.63471 7.17184 -0.0924634 0.45212 0.606799 +450 1 4.40759 4.53436 7.23701 0.160045 0.252781 -1.03281 +451 1 4.47938 3.49218 8.04219 0.177099 0.0940276 0.00712601 +452 1 3.55379 4.48752 8.06012 -0.927856 0.341505 -0.0833457 +453 1 5.30335 3.52949 7.1279 2.00125 1.71282 0.0663191 +454 1 6.19233 4.44015 7.09395 -0.123778 -0.82645 0.684973 +455 1 6.31698 3.55227 8.05766 -1.80584 -0.932697 -1.1518 +456 1 5.41804 4.43351 8.09204 -4.30063 -0.218755 -3.96516 +457 1 7.232 3.50321 7.24512 -0.569054 0.129485 -1.05452 +458 1 8.04777 4.39134 7.10023 -0.415559 1.27013 1.1937 +459 1 8.09921 3.54644 7.99275 -0.904288 0.185761 1.62031 +460 1 7.15284 4.38151 8.0646 -0.281528 0.0795406 -1.17401 +461 1 8.85944 5.36104 7.19522 1.71386 -0.372777 -2.67299 +462 1 0.808445 6.15874 7.05432 0.343929 1.70028 2.25424 +463 1 0.99266 5.36055 8.05319 -1.96195 -0.361049 -1.35199 +464 1 8.9228 6.22111 8.03716 -0.328906 0.253391 -0.16959 +465 1 1.7511 5.27554 7.16317 -0.501838 -0.493478 -1.59379 +466 1 2.7323 6.31099 7.08452 0.463177 0.0720173 0.389338 +467 1 2.75106 5.38162 8.09911 0.530948 -0.923774 -0.761524 +468 1 1.80446 6.33727 8.00982 0.567564 -0.353842 0.999402 +469 1 3.53218 5.32026 7.15711 1.3552 1.44822 0.141569 +470 1 4.49512 6.19462 7.20137 -2.95094 2.57244 -4.09211 +471 1 4.4829 5.43783 8.04952 -1.75843 -3.70774 -0.194014 +472 1 3.65767 6.24252 7.97233 -2.18137 -0.334806 -0.189717 +473 1 5.35752 5.46295 7.14871 1.05371 -2.23541 -1.50951 +474 1 6.22804 6.29485 7.12141 -0.370188 0.264704 -0.149428 +475 1 6.34127 5.4593 8.01496 -0.759119 0.239406 -0.0100712 +476 1 5.27101 6.21963 7.98358 4.21356 3.70888 3.53999 +477 1 7.2413 5.39744 7.15422 0.63332 0.408861 0.0765336 +478 1 8.01209 6.33115 7.20214 1.04149 -1.50251 -0.643312 +479 1 8.11155 5.33363 8.02803 -2.08279 1.51127 0.153008 +480 1 7.20203 6.31049 8.06426 -0.105023 -0.935886 0.140492 +481 1 8.92362 7.24394 7.10015 0.0792153 -3.18157 4.09933 +482 1 0.865164 8.02092 7.22606 2.85769 1.65383 -2.61434 +483 1 0.86745 7.15339 8.01815 -0.578541 -0.380635 0.364655 +484 1 0.0284189 8.08161 7.95725 -0.890268 -0.349283 1.10066 +485 1 1.85656 7.22057 7.11535 0.397315 -1.70504 3.16253 +486 1 2.77375 7.96501 7.15423 0.0953595 0.0574297 -0.272157 +487 1 2.64437 7.22314 8.11966 1.48696 -0.179689 -2.12782 +488 1 1.85941 8.11413 7.96635 -2.35368 -2.50728 -0.754549 +489 1 3.67468 7.10829 7.12824 0.65987 0.70298 0.656082 +490 1 4.46621 7.99739 7.2078 2.25404 -0.456947 -2.59682 +491 1 4.48001 7.09955 8.01357 0.0334801 0.324585 -0.290932 +492 1 3.6378 8.02597 7.95299 -1.96867 -0.619231 2.20677 +493 1 5.31589 7.17259 7.15585 0.23145 -0.930936 -0.437425 +494 1 6.20936 8.03122 7.09513 -0.13604 -0.296447 0.152582 +495 1 6.17543 7.22187 8.09898 5.44884 -7.61495 -1.62058 +496 1 5.43883 7.98222 8.0181 -6.37262 6.00913 -1.00537 +497 1 7.14576 7.09705 7.14015 0.407174 1.49093 0.0363952 +498 1 8.02588 8.07609 7.1284 1.43118 -1.40285 -0.689018 +499 1 7.99317 7.15919 8.00286 1.19218 0.601266 0.682892 +500 1 7.2435 8.04597 7.97482 -1.89044 -0.246287 0.1524 +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +500 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 8.5498797333834844e+00 +0.0000000000000000e+00 8.5498797333834844e+00 +0.0000000000000000e+00 8.5498797333834844e+00 +ITEM: ATOMS id type x y z f_1[1] f_1[2] f_1[3] +1 1 0.0109462 8.52194 8.48789 1.60777 3.16074 4.93288 +2 1 0.770239 0.886587 0.0775241 5.1148 0.619933 -4.35337 +3 1 0.914855 8.54009 0.795212 -2.54709 2.40671 3.27622 +4 1 8.53949 0.79582 0.824294 -1.87361 -0.316163 2.22706 +5 1 1.68126 8.45058 8.49491 -0.796772 17.9401 13.8601 +6 1 2.49257 0.906431 0.000759221 8.8197 -0.476032 2.96817 +7 1 2.62932 0.0354753 0.888378 -4.43263 -0.45206 -5.76212 +8 1 1.71329 0.913566 0.778252 -3.74188 -4.37189 3.26227 +9 1 3.42175 0.0965993 8.49503 -4.75784 -8.08943 10.1901 +10 1 4.21271 0.889278 8.46971 8.07159 3.26979 7.09905 +11 1 4.30903 0.0721078 0.771319 -2.20196 2.16322 3.01896 +12 1 3.42332 0.912751 0.876126 -1.2014 -0.27869 -2.68959 +13 1 5.04057 8.48132 8.46735 12.114 4.06773 4.60111 +14 1 5.95626 0.830289 0.0884189 2.64036 5.56585 -7.9642 +15 1 5.95178 0.0392781 0.802073 0.496214 -5.11156 5.55524 +16 1 5.1151 0.919125 0.80056 -4.53937 -3.75487 2.57161 +17 1 6.8031 8.46299 8.54479 -1.12262 1.88258 -1.67969 +18 1 7.77702 0.837169 8.46101 -2.81144 0.601723 4.97774 +19 1 7.61766 0.0190488 0.807902 2.02145 -3.01975 -0.996798 +20 1 6.83813 0.841817 0.893784 2.20091 1.15146 -3.46095 +21 1 0.00483518 1.7748 8.45086 3.14001 0.0124508 7.14446 +22 1 0.925315 2.54775 8.47859 -2.14676 3.17757 1.68537 +23 1 0.946475 1.73152 0.932031 -7.90083 -3.0997 -5.49951 +24 1 0.0820864 2.59152 0.95052 -16.5003 -1.1863 -19.4267 +25 1 1.62363 1.68342 8.4651 1.8496 1.86303 2.33818 +26 1 2.56251 2.66233 0.0202936 -6.7309 -4.60627 -0.0436147 +27 1 2.47347 1.71611 0.900003 2.27232 1.93928 0.205074 +28 1 1.66562 2.5538 0.89239 8.29789 -0.0162708 -2.14995 +29 1 3.47808 1.70927 8.49067 -6.21947 -0.00998514 1.91211 +30 1 4.19294 2.51037 0.0787296 16.1199 8.28753 -17.6776 +31 1 4.29711 1.73051 0.787489 0.142042 -5.75402 7.11231 +32 1 3.43681 2.6439 0.75999 -11.309 -9.11906 21.9869 +33 1 5.20599 1.76704 0.0398807 -10.2389 -11.7619 -5.76949 +34 1 5.91436 2.52733 8.51501 10.4145 9.83206 -1.49498 +35 1 5.9033 1.67223 0.919622 10.1161 4.25667 -5.1777 +36 1 5.15205 2.55373 0.788133 -1.76953 2.31199 6.90362 +37 1 6.92232 1.70971 0.0701593 -2.50899 -1.62202 -0.822044 +38 1 7.5955 2.61765 0.0592135 2.55821 0.640647 0.0382532 +39 1 7.74881 1.7729 0.896218 -1.59166 -5.96851 -6.46077 +40 1 6.80231 2.56106 0.910949 5.84287 -4.44794 -4.99646 +41 1 0.028349 3.48236 8.49963 2.5025 -5.04288 3.39467 +42 1 0.836484 4.27887 0.0816773 0.760548 2.93196 -2.43461 +43 1 0.942186 3.3633 0.783926 -3.69777 5.09684 -0.0674025 +44 1 8.51583 4.33027 0.838505 2.60137 -0.826864 1.21094 +45 1 1.65067 3.4812 8.47243 0.730068 -2.57113 1.91442 +46 1 2.5668 4.2649 8.54781 -0.773361 3.29166 6.51609 +47 1 2.51515 3.35935 0.92744 0.397687 12.5391 -13.0985 +48 1 1.73465 4.30243 0.83421 -1.47193 -2.67124 0.923933 +49 1 3.37869 3.37397 0.0291446 3.12688 15.3224 -6.53558 +50 1 4.34738 4.34434 0.00829503 -5.52046 -6.93359 -2.07611 +51 1 4.32411 3.36572 0.836745 -2.16657 1.87946 3.00206 +52 1 3.33524 4.20214 0.9322 3.17725 3.34929 -6.83564 +53 1 5.08499 3.41929 0.036632 4.03928 -2.58738 -4.81317 +54 1 6.04127 4.33974 8.49644 -0.624803 -0.102814 0.982479 +55 1 6.01611 3.33685 0.909561 -5.08671 5.06768 -6.62403 +56 1 5.207 4.2377 0.760733 -1.32975 0.891019 3.81461 +57 1 6.81304 3.47817 0.0178755 -0.843928 -8.06693 -2.50137 +58 1 7.73203 4.2048 0.00740382 -1.99245 1.66716 -1.57857 +59 1 7.78831 3.44874 0.953497 -3.78613 -1.03229 -4.77194 +60 1 6.90781 4.17709 0.825008 -1.46363 4.64194 5.22986 +61 1 8.46845 5.09622 8.47404 12.6898 1.90364 12.9104 +62 1 0.797366 5.93181 8.52222 2.38416 2.33873 2.4531 +63 1 0.806155 5.19524 0.885366 4.86564 -4.44474 -2.27198 +64 1 0.0123025 5.95271 0.830227 -4.90982 1.72838 0.59014 +65 1 1.70825 5.09756 8.50872 2.27411 3.17124 11.7261 +66 1 2.57892 5.99612 8.47434 -1.64581 0.780097 1.78814 +67 1 2.53606 5.08073 0.912891 1.82428 2.12405 0.338003 +68 1 1.76245 6.06361 0.855052 -0.817516 -1.26047 -0.587481 +69 1 3.36815 5.1611 0.0892763 -1.75416 -1.94918 -4.15038 +70 1 4.34388 5.99478 8.53994 -9.12199 -5.82315 -0.643131 +71 1 4.22842 5.14974 0.779802 4.93843 -0.926739 3.98855 +72 1 3.45177 5.94376 0.905424 -5.40353 3.18508 -3.48186 +73 1 5.06545 5.13306 8.4631 8.02458 6.68819 3.23791 +74 1 5.91929 6.01015 8.53548 3.77131 -1.20656 -2.03594 +75 1 5.88805 5.11842 0.816496 5.73582 1.96394 -4.01157 +76 1 5.18785 6.02276 0.820364 -9.36617 -3.77225 -2.84856 +77 1 6.8933 5.1517 8.49766 -1.10898 -0.445881 0.788116 +78 1 7.73242 5.99103 8.48869 1.48322 -7.68495 9.10162 +79 1 7.66553 5.0457 0.7869 0.413505 3.32493 1.60624 +80 1 6.9298 5.9353 0.896867 -3.44217 0.759559 -1.89572 +81 1 0.0757853 6.76414 0.08264 -2.09776 5.63137 -2.35842 +82 1 0.929754 7.68563 0.0937614 -14.24 2.10473 -10.1605 +83 1 0.947372 6.93568 0.898093 -37.7638 -41.2899 -5.14895 +84 1 0.0463649 7.75037 0.902481 -0.259219 -2.38896 -3.08434 +85 1 1.64115 6.89463 8.52754 6.28385 -7.53573 1.49633 +86 1 2.53763 7.75472 8.45351 15.1175 -6.89071 16.4408 +87 1 2.60347 6.88355 0.853331 -4.53589 -3.86491 -4.69681 +88 1 1.61173 7.63221 0.905993 43.7793 33.7511 -1.13346 +89 1 3.3813 6.82692 8.54355 -0.238432 1.95456 2.34043 +90 1 4.24371 7.77989 0.043504 -5.67067 -7.72392 -1.84442 +91 1 4.1828 6.86814 0.818276 1.21815 -0.827933 0.630987 +92 1 3.3368 7.7382 0.923275 7.52639 -2.01137 -4.72269 +93 1 5.071 6.7563 0.010658 5.49209 11.6713 -3.15323 +94 1 5.90188 7.6356 0.0424163 1.86621 0.862931 -1.97936 +95 1 6.03172 6.8673 0.938495 -1.34369 1.09475 -9.39496 +96 1 5.15248 7.77523 0.857214 -2.90101 -1.73408 2.05686 +97 1 6.89959 6.76423 0.01648 -11.1028 0.34724 0.750719 +98 1 7.65506 7.70409 0.0429309 2.74021 -1.34663 -2.67212 +99 1 7.64597 6.8087 0.792436 6.14337 0.285334 5.54838 +100 1 6.81299 7.61529 0.784654 1.50923 3.73377 2.87701 +101 1 0.039157 8.46192 1.76149 -3.85041 1.88762 -2.12951 +102 1 0.799188 0.819633 1.69376 4.21763 0.723161 -3.63495 +103 1 0.763005 0.0408753 2.55669 11.5628 -1.30287 -1.53659 +104 1 0.0652633 0.934891 2.49039 -5.1145 -1.67274 5.33691 +105 1 1.66381 8.45402 1.66249 1.87623 5.22247 1.17986 +106 1 2.503 0.802578 1.65731 0.0918423 3.77669 3.70231 +107 1 2.51579 0.0135642 2.53917 0.463256 0.0266605 -0.815012 +108 1 1.65685 0.926197 2.57259 5.9178 -9.1905 -0.306187 +109 1 3.4242 0.0443963 1.67808 1.33331 -0.794171 2.32841 +110 1 4.23298 0.877511 1.6619 2.15651 0.36791 0.599305 +111 1 4.23114 8.48221 2.59613 0.139704 5.19667 3.26797 +112 1 3.42382 0.825355 2.52764 0.831325 -0.597344 0.750298 +113 1 5.10755 0.098598 1.64667 1.13835 -0.15217 0.418453 +114 1 6.07979 0.861483 1.66377 -9.38879 -3.1028 5.61252 +115 1 6.06362 0.0403691 2.64895 -6.98521 -8.98289 -11.9164 +116 1 5.20913 0.939312 2.59362 -1.28414 -1.16831 -2.67638 +117 1 6.75529 8.52816 1.79359 4.36806 -0.709446 -4.01445 +118 1 7.76101 0.764033 1.62558 -1.73868 3.93794 4.49945 +119 1 7.66206 0.0708021 2.53607 1.47505 -2.32899 1.29594 +120 1 6.92286 0.947435 2.52138 -4.88314 -16.5943 7.22153 +121 1 8.51449 1.72985 1.71942 6.76951 -3.05423 -0.995536 +122 1 0.834691 2.62553 1.61171 16.0236 -0.437826 23.4167 +123 1 0.945534 1.71145 2.53519 -17.6422 5.766 10.6769 +124 1 8.53575 2.60321 2.48391 2.61084 -9.58061 10.2444 +125 1 1.63294 1.72028 1.76938 14.1815 -0.440268 -11.5313 +126 1 2.57682 2.65502 1.67415 2.8611 -15.9615 10.724 +127 1 2.65189 1.65955 2.48962 -4.47742 1.085 2.58429 +128 1 1.79145 2.49644 2.55538 0.0425348 2.96537 1.56716 +129 1 3.45687 1.73281 1.73911 -3.75938 -0.279924 -8.91417 +130 1 4.34908 2.51749 1.7514 -3.12574 5.69408 -7.34516 +131 1 4.21985 1.73239 2.48294 4.56177 -5.44217 8.83153 +132 1 3.39941 2.5984 2.48766 0.0932155 -0.49927 3.02478 +133 1 5.22539 1.80308 1.7328 -5.21779 -2.43895 2.23844 +134 1 6.07426 2.60134 1.71356 -9.82102 -9.11759 6.53349 +135 1 6.06098 1.72463 2.48049 -24.0059 1.32147 25.9525 +136 1 5.04217 2.48583 2.60699 6.13261 3.37855 2.31458 +137 1 6.77443 1.68358 1.80416 26.2694 11.8834 -33.3324 +138 1 7.78345 2.52468 1.65191 -10.0717 7.23238 6.81167 +139 1 7.67217 1.70427 2.51662 7.38759 5.50979 0.483479 +140 1 6.87655 2.54802 2.65887 0.828003 6.30102 -11.6733 +141 1 8.48905 3.38009 1.79052 3.95862 11.358 -4.16794 +142 1 0.904648 4.31805 1.73458 -1.64595 0.0791848 -3.59387 +143 1 0.882159 3.48871 2.5578 -1.47386 -2.40831 0.515883 +144 1 0.0640856 4.36164 2.51005 -1.54232 -2.6948 -1.06039 +145 1 1.78366 3.38548 1.78248 -8.79706 -1.19951 -6.15917 +146 1 2.61647 4.18826 1.75601 -13.6767 13.2656 0.0962066 +147 1 2.49967 3.46972 2.59724 11.287 -7.88562 -0.187146 +148 1 1.72994 4.21494 2.4741 -1.76295 10.5241 6.69302 +149 1 3.35408 3.46945 1.74549 12.0923 -11.3982 2.63093 +150 1 4.33371 4.2573 1.65266 -1.0572 -0.0681575 -0.357999 +151 1 4.25135 3.37501 2.62082 -0.724851 2.23609 -3.08367 +152 1 3.37046 4.34755 2.6064 0.218455 -8.01846 -3.14612 +153 1 5.16664 3.3978 1.80383 -2.26051 -2.46633 -4.30603 +154 1 6.02075 4.21565 1.63908 -0.444656 2.88859 -0.464916 +155 1 6.04443 3.46025 2.46975 -2.50911 -3.21487 7.82311 +156 1 5.06457 4.21348 2.57808 1.01082 5.99339 -2.31274 +157 1 6.80721 3.3694 1.6818 12.0846 7.00158 1.77966 +158 1 7.66426 4.31037 1.75089 1.93845 -1.12426 -1.15071 +159 1 7.67666 3.35746 2.66226 0.0349977 1.35377 -1.51011 +160 1 6.86746 4.18845 2.58559 1.34212 2.76274 1.29577 +161 1 0.0121787 5.21746 1.67805 -1.66136 -3.05338 2.49187 +162 1 0.848043 6.06063 1.634 -1.152 -1.54074 2.03353 +163 1 0.891535 5.1714 2.53903 -1.80088 0.0367987 2.5043 +164 1 8.53141 6.02479 2.48115 1.46529 0.600203 2.28151 +165 1 1.67096 5.18637 1.75513 2.90335 -0.353263 -4.03581 +166 1 2.63344 6.0279 1.70432 -16.3644 -8.57778 -6.55322 +167 1 2.48532 5.10477 2.59913 0.462017 -0.718364 -1.79537 +168 1 1.74617 5.95248 2.59859 0.0442724 3.34654 -0.327538 +169 1 3.3871 5.11741 1.76498 -0.70902 0.100622 -1.55997 +170 1 4.23897 5.91622 1.65627 3.82091 1.24022 3.5679 +171 1 4.18272 5.19526 2.64844 4.07887 -0.154168 -2.99301 +172 1 3.33243 6.04257 2.48749 13.2178 -9.29314 8.76503 +173 1 5.21355 5.13048 1.6694 -5.38913 -0.724028 1.81762 +174 1 5.88731 6.04999 1.61164 27.08 -23.484 7.87668 +175 1 5.91685 5.19555 2.55373 8.22272 -5.32197 -1.91553 +176 1 5.22513 6.01752 2.48789 -6.37641 3.03262 4.81469 +177 1 6.87923 5.14396 1.75241 -1.31228 -0.52571 -0.175031 +178 1 7.66325 6.00346 1.75398 1.55065 0.721262 -1.56625 +179 1 7.71088 5.21107 2.64045 -0.197441 -3.63935 -3.47269 +180 1 6.81367 6.03163 2.50271 -0.887486 -5.65654 8.47366 +181 1 8.45469 6.86312 1.68381 5.32955 -1.93357 -1.0964 +182 1 0.887234 7.64699 1.70441 -8.03342 4.67955 6.65869 +183 1 0.827773 6.84361 2.49826 0.666014 -0.927683 2.41577 +184 1 0.0243326 7.6531 2.64337 -2.41729 -1.59288 -7.26092 +185 1 1.67566 6.82407 1.70759 6.3287 0.149047 4.42322 +186 1 2.51454 7.65687 1.63227 -3.24159 2.2536 7.24906 +187 1 2.61047 6.80534 2.59521 -8.48569 7.62473 -2.75927 +188 1 1.62469 7.75189 2.55083 1.70283 -3.32336 -0.400725 +189 1 3.32845 6.81114 1.68061 10.3844 9.25335 0.5217 +190 1 4.35781 7.7751 1.79868 -7.49989 -3.23754 -13.7369 +191 1 4.19243 6.92819 2.60428 15.2501 -13.591 -1.36339 +192 1 3.43706 7.60555 2.52571 -13.7857 14.6138 -0.968483 +193 1 5.20185 6.77695 1.66316 -21.9331 19.6829 3.32007 +194 1 5.90138 7.62608 1.77842 3.59956 5.50204 -2.20333 +195 1 5.95566 6.93899 2.64467 1.5684 -14.0837 -9.48217 +196 1 5.06902 7.62841 2.55428 6.74225 1.46675 8.63059 +197 1 6.76742 6.8085 1.78801 1.36869 6.36826 -6.59728 +198 1 7.65843 7.62584 1.68675 -2.22178 4.8322 -2.62428 +199 1 7.67415 6.89867 2.52463 2.21143 -5.15334 3.5596 +200 1 6.87662 7.66202 2.55284 -3.26152 2.73313 1.32325 +201 1 0.0405641 8.51038 3.32948 -5.92557 3.54592 8.59039 +202 1 0.809165 0.908392 3.38948 1.71953 -1.70344 0.923667 +203 1 0.901714 8.46653 4.19384 -9.71216 4.93867 8.34322 +204 1 0.069999 0.928448 4.31429 -4.27362 -2.53344 -6.14786 +205 1 1.6264 8.4509 3.42354 8.98155 6.03203 -6.76996 +206 1 2.65602 0.762944 3.43842 -5.54094 5.64927 -11.0802 +207 1 2.61793 0.0468587 4.22961 -1.55064 -6.54911 6.6458 +208 1 1.68094 0.888048 4.32275 0.711784 -4.72688 -3.71581 +209 1 3.43429 8.45723 3.40115 7.64008 12.4108 0.619842 +210 1 4.23416 0.880739 3.42582 5.39503 -6.32873 -0.402512 +211 1 4.18642 8.4609 4.33191 11.6244 16.7018 2.29066 +212 1 3.36155 0.898574 4.22656 4.93072 -1.64922 5.55995 +213 1 5.13206 0.0787666 3.45034 -0.945527 -3.11163 -2.8253 +214 1 6.05542 0.815095 3.33818 0.680768 11.3265 10.7561 +215 1 5.88615 0.068379 4.32153 11.9175 -9.57172 -8.45948 +216 1 5.21525 0.885851 4.19789 -5.15816 5.54694 4.34946 +217 1 6.80589 8.45257 3.40423 5.88256 0.0541198 6.21084 +218 1 7.74454 0.870555 3.46229 0.501904 -4.05279 -5.44709 +219 1 7.62711 0.0144156 4.35804 1.95636 -0.757148 -6.431 +220 1 6.7475 0.756319 4.34542 2.82117 3.60456 -0.442947 +221 1 0.046471 1.74765 3.48426 -2.94726 0.460616 -2.28233 +222 1 0.888532 2.54472 3.37968 0.966992 1.17998 0.546373 +223 1 0.832134 1.79852 4.28422 5.1168 -14.8036 -11.8055 +224 1 0.0855384 2.60849 4.37243 -9.37894 3.13224 -11.0091 +225 1 1.76053 1.64213 3.45381 -3.40447 2.71972 -2.85028 +226 1 2.52635 2.61582 3.43297 3.65437 -1.51294 -3.08517 +227 1 2.50122 1.75788 4.25552 8.72555 -0.689386 -1.86072 +228 1 1.75205 2.6278 4.21833 -8.89154 -5.54607 2.69229 +229 1 3.50205 1.65486 3.36684 -7.50491 6.39615 -0.836562 +230 1 4.28152 2.60594 3.4252 -1.76945 -2.76432 2.53661 +231 1 4.17705 1.67239 4.28707 6.76533 -1.25356 -1.29705 +232 1 3.44438 2.47178 4.25656 -4.81944 5.002 -0.576402 +233 1 5.22486 1.68937 3.43619 -3.28026 2.78772 -4.39101 +234 1 6.02069 2.55292 3.33778 -3.72236 0.507942 3.01424 +235 1 5.96152 1.77008 4.23889 4.98563 -0.248026 3.40967 +236 1 5.17107 2.61009 4.24734 -0.598251 0.473097 -0.376582 +237 1 6.87337 1.72985 3.32607 -2.78397 -6.76638 7.83701 +238 1 7.692 2.50127 3.44714 2.52098 2.71173 -0.194497 +239 1 7.63531 1.64894 4.19535 0.881487 3.19892 6.53537 +240 1 6.92924 2.5559 4.32195 -3.68781 1.74243 -2.92343 +241 1 0.0154582 3.42553 3.38818 0.573657 0.250438 1.11994 +242 1 0.946668 4.34133 3.49534 -14.1263 -16.7645 -9.90419 +243 1 0.911751 3.43019 4.31621 -0.850264 0.755291 -1.68921 +244 1 0.0046042 4.25775 4.34424 -1.31738 -1.24756 -1.54253 +245 1 1.76086 3.48229 3.3966 -12.418 -8.98763 3.21891 +246 1 2.48605 4.22978 3.40508 14.0841 10.3397 -4.15997 +247 1 2.54799 3.33831 4.30225 4.92033 13.8543 -7.00111 +248 1 1.7676 4.3622 4.17566 0.280546 -16.6448 26.3844 +249 1 3.37038 3.45998 3.42173 -0.200746 -1.45028 -1.29578 +250 1 4.20874 4.30541 3.50172 4.65367 -11.48 -19.1828 +251 1 4.21154 3.43635 4.23457 4.19917 -3.40534 2.03948 +252 1 3.45806 4.23712 4.25878 -8.55751 2.75292 6.08306 +253 1 5.11168 3.47839 3.3691 -0.311412 -5.69502 5.70804 +254 1 5.92148 4.26406 3.41002 5.13821 -1.04796 0.0327238 +255 1 6.02264 3.46008 4.23226 -3.02748 -3.55814 1.41554 +256 1 5.17114 4.24863 4.35423 -2.77791 4.93248 -13.0008 +257 1 6.86557 3.34851 3.50434 -4.54964 -0.0741147 -9.06001 +258 1 7.67607 4.29403 3.50495 4.02814 6.65377 -10.7943 +259 1 7.67432 3.49417 4.17544 8.6417 -11.3672 14.2425 +260 1 6.8466 4.22166 4.23144 -3.46256 4.46394 4.938 +261 1 0.0814499 5.05812 3.37338 -2.94602 3.43381 2.0972 +262 1 0.952662 5.9924 3.43554 -2.60446 0.4469 0.54362 +263 1 0.765082 5.07607 4.26673 5.31334 4.0071 5.5605 +264 1 0.0672914 5.95184 4.29838 -1.77164 3.23629 -2.96482 +265 1 1.64676 5.09677 3.49021 9.45599 25.7387 -15.7709 +266 1 2.59524 6.06011 3.441 -1.69946 -11.0916 -4.14222 +267 1 2.46878 5.21999 4.3176 5.41184 -22.6386 -22.4739 +268 1 1.72435 5.99765 4.33067 -8.961 3.18884 -2.81076 +269 1 3.33576 5.13502 3.32819 -1.95672 4.97188 10.3591 +270 1 4.33219 6.01601 3.4905 -3.43576 -1.4684 -1.43775 +271 1 4.2868 5.05318 4.19611 2.54498 12.874 12.0539 +272 1 3.47487 5.92769 4.31716 -1.095 0.823289 -0.856965 +273 1 5.22135 5.10776 3.40172 -8.93936 2.06172 1.30023 +274 1 6.0405 5.92456 3.43523 0.724841 2.24513 0.144002 +275 1 5.92006 5.1314 4.26005 8.25611 -3.42587 -2.20917 +276 1 5.11155 5.91401 4.29084 1.00396 1.28478 -0.181662 +277 1 6.86476 5.07118 3.47111 -5.70253 1.83988 -3.65428 +278 1 7.60709 5.97166 3.43329 1.57958 3.02153 1.22094 +279 1 7.62121 5.17116 4.25108 13.415 -9.76593 -1.32536 +280 1 6.90725 5.93696 4.35438 -12.0061 10.5099 -5.89092 +281 1 0.0158532 6.88433 3.5005 2.50125 -3.66413 -3.15884 +282 1 0.832759 7.6858 3.39159 0.810583 -3.83454 1.16734 +283 1 0.879361 6.87893 4.25184 1.06811 -4.80567 -3.71366 +284 1 8.48025 7.67569 4.32838 6.71448 4.3067 1.89144 +285 1 1.76699 6.83608 3.37875 -3.92913 2.06189 -0.762911 +286 1 2.64337 7.79272 3.38564 -11.5742 -11.6301 0.504133 +287 1 2.51611 6.79594 4.20547 2.9771 6.7763 8.40555 +288 1 1.73472 7.75634 4.30153 3.5376 -4.65751 1.06495 +289 1 3.42458 6.78486 3.36363 0.711862 2.92454 6.30952 +290 1 4.29146 7.78029 3.51531 3.92856 -8.43358 -6.61451 +291 1 4.22796 6.89496 4.356 2.49253 -3.58746 -4.19183 +292 1 3.49073 7.69895 4.31251 -15.4332 -7.21194 0.0843114 +293 1 5.03295 6.88949 3.43613 2.4132 0.715094 1.20127 +294 1 5.9914 7.60738 3.43115 0.166605 10.2994 10.8333 +295 1 6.06057 6.76316 4.28526 -0.682389 0.774521 0.518315 +296 1 5.1506 7.68481 4.35956 -0.587179 -0.831286 -4.17718 +297 1 6.91829 6.87557 3.41173 -2.20287 0.087574 0.74732 +298 1 7.77376 7.66664 3.47631 -5.20912 2.94829 -3.10686 +299 1 7.7733 6.85147 4.2793 -6.28798 -5.26886 2.97867 +300 1 6.79627 7.70864 4.34123 1.13479 0.471756 -2.41754 +301 1 8.47537 0.0666715 5.07785 3.07732 -2.35936 2.36099 +302 1 0.837862 0.824189 5.08442 2.67015 -0.0526079 4.2528 +303 1 0.947354 8.53746 5.97515 -9.44477 -2.06512 3.38353 +304 1 8.45527 0.903487 5.90211 4.35699 -8.49334 13.6006 +305 1 1.71466 0.0614796 5.21675 1.71751 -10.7388 -14.8483 +306 1 2.56545 0.785351 5.1483 1.0332 2.19745 -1.75997 +307 1 2.58448 8.48208 5.91956 0.430753 0.76971 3.58164 +308 1 1.65003 0.816215 5.93197 3.03102 12.7849 8.36083 +309 1 3.46033 0.0141985 5.16494 -4.25366 -0.783326 -0.484155 +310 1 4.20213 0.929517 5.13838 2.42665 -3.78185 -0.152962 +311 1 4.26733 0.0836521 5.92638 3.25998 -1.091 1.74874 +312 1 3.41102 0.861262 6.03148 -0.949591 0.0559607 -1.66554 +313 1 5.1564 8.53616 5.06672 -11.5945 -0.673098 9.37255 +314 1 5.94115 0.761043 5.20173 4.62182 33.122 -29.3364 +315 1 5.93463 0.0696556 5.8868 1.75697 -30.8547 30.3151 +316 1 5.14065 0.9256 5.95741 -0.006185 -4.789 2.4932 +317 1 6.91953 8.50208 5.18386 -10.6338 4.52372 2.129 +318 1 7.72317 0.898909 5.10883 -6.55365 -0.206627 -4.30053 +319 1 7.67728 0.0288812 5.99182 2.50541 0.776267 0.642418 +320 1 6.91834 0.891409 5.91811 -4.13582 -0.84176 -0.41985 +321 1 0.0355634 1.62397 5.15959 0.786537 13.0999 -7.10363 +322 1 0.855042 2.4658 5.05819 10.8208 10.8619 21.426 +323 1 0.798893 1.71459 6.01685 5.79471 -4.43182 -0.915803 +324 1 0.0659206 2.49237 5.91102 -5.57064 6.4328 0.916789 +325 1 1.77633 1.69788 5.04117 -5.55508 3.43302 7.46453 +326 1 2.55086 2.64298 5.08873 0.0193134 -8.77259 6.85672 +327 1 2.49765 1.63315 5.92814 1.12021 1.50275 1.88199 +328 1 1.80539 2.621 5.95731 -6.21714 -3.35524 -0.269961 +329 1 3.34329 1.63256 5.07699 -2.20219 4.06192 2.43743 +330 1 4.31458 2.52073 5.06335 -0.0632538 1.3392 1.20942 +331 1 4.33916 1.68863 5.97126 -3.41941 3.44417 2.01134 +332 1 3.42212 2.64548 5.89276 -0.0280586 -2.67425 3.44656 +333 1 5.16333 1.72803 5.18363 0.62931 0.268233 -3.53629 +334 1 5.97493 2.53755 5.18126 5.42417 -2.99996 -10.5798 +335 1 5.97644 1.77632 6.05208 2.30795 -0.932212 -2.38345 +336 1 5.20771 2.64035 5.9206 -9.19429 -1.91265 5.67918 +337 1 6.82113 1.7288 5.07227 0.319047 -2.27809 2.42075 +338 1 7.76584 2.66005 5.04767 0.36372 -2.98667 3.98468 +339 1 7.68048 1.73285 5.98682 1.83082 2.55026 -3.35109 +340 1 6.77723 2.66049 6.0628 11.9195 -28.0419 -0.192401 +341 1 8.52926 3.48894 5.20725 0.756027 -4.20422 -2.12394 +342 1 0.880496 4.18659 5.21886 -2.21024 5.88812 -5.98946 +343 1 0.823278 3.46696 6.03218 3.03891 -2.5906 1.31712 +344 1 8.45604 4.28238 5.97679 3.43734 -0.298701 2.3281 +345 1 1.66848 3.43018 5.1681 4.45896 -2.65722 -0.776378 +346 1 2.47623 4.29797 5.21376 10.0204 -9.1421 -8.64412 +347 1 2.46945 3.49538 6.0664 15.3766 -12.245 -4.5397 +348 1 1.75883 4.22715 6.00615 -17.7933 12.7993 4.23364 +349 1 3.32535 3.48763 5.18919 1.16348 3.11251 -2.54898 +350 1 4.29953 4.30461 5.21296 -7.48003 6.57243 -13.8987 +351 1 4.32836 3.50006 5.90127 -9.25916 -18.9556 4.88449 +352 1 3.45987 4.23872 6.06433 -4.26661 1.09432 -3.11516 +353 1 5.16317 3.46797 5.05136 -2.20358 -10.3645 8.38524 +354 1 6.01128 4.18674 5.11415 3.72823 2.851 1.21774 +355 1 6.05124 3.32995 5.89897 -17.0823 24.7049 3.10753 +356 1 5.05098 4.23901 5.94533 18.4684 10.5132 6.34816 +357 1 6.93195 3.37363 5.21832 -12.1973 3.61502 -16.8233 +358 1 7.67472 4.24466 5.1448 -0.046387 1.44369 -2.14451 +359 1 7.59877 3.3598 5.99617 16.3705 11.4653 3.48987 +360 1 6.9163 4.33093 6.01136 -0.884888 -0.827495 0.436994 +361 1 8.47485 5.1618 5.06757 4.58611 -6.95556 3.64111 +362 1 0.866551 5.92561 5.22826 -2.4458 0.731452 -4.83922 +363 1 0.856029 5.03088 5.93872 -0.961264 1.16585 2.50638 +364 1 0.025531 6.08363 6.03301 -0.603503 -3.86392 0.433571 +365 1 1.73882 5.05771 5.16436 -7.87894 6.49017 -0.085231 +366 1 2.54586 5.89415 5.04217 4.79689 21.4637 24.3945 +367 1 2.63875 5.11717 5.9033 -10.4096 0.222879 12.4433 +368 1 1.7282 6.02787 5.89482 3.82714 -3.17245 6.07309 +369 1 3.41343 5.11888 5.19776 7.89672 -3.25441 -9.4893 +370 1 4.34849 6.08405 5.13729 -6.43313 -7.37614 1.57014 +371 1 4.30919 5.18003 6.06007 -0.523489 -1.53897 -0.492658 +372 1 3.32135 5.97978 5.88753 6.80953 0.93257 3.29984 +373 1 5.2281 5.04347 5.09516 -5.81719 1.07839 6.76004 +374 1 5.94602 5.8851 5.09539 3.02249 4.44225 2.10278 +375 1 6.04092 5.17575 6.07061 0.50428 -9.39491 -12.3653 +376 1 5.21437 6.06631 6.06016 -6.35945 -8.11006 -13.4627 +377 1 6.91579 5.12007 5.08308 -5.11836 -4.49572 6.409 +378 1 7.70983 5.91053 5.07808 1.5309 9.32926 6.58643 +379 1 7.76683 5.15653 6.01534 -1.66429 -5.18049 -8.59085 +380 1 6.93784 6.03915 5.96221 -25.2768 -19.3137 -6.75792 +381 1 0.0625638 6.74931 5.10819 -0.676634 2.54846 -0.0250987 +382 1 0.86361 7.61298 5.03345 -2.5044 7.0388 6.38474 +383 1 0.851706 6.88156 6.03092 0.201379 -3.97494 -1.33706 +384 1 0.0506067 7.6425 5.89338 -1.769 2.22377 0.622415 +385 1 1.66322 6.86583 5.19561 3.09287 -3.33398 -7.05581 +386 1 2.62799 7.62451 5.17609 -27.9662 28.0267 -4.59006 +387 1 2.66202 6.83135 5.96842 -24.8289 -0.817724 19.495 +388 1 1.64735 7.66733 5.92394 4.49398 5.54382 1.70924 +389 1 3.32274 6.93842 5.22499 45.6897 -26.2601 -20.0997 +390 1 4.28266 7.68312 5.1494 -0.162983 0.307259 3.3477 +391 1 4.21122 6.74188 6.04596 -0.795282 5.66715 -3.63702 +392 1 3.40786 7.67271 6.05784 2.18013 1.35082 -0.335047 +393 1 5.13386 6.80127 5.05013 6.80473 4.27889 3.23937 +394 1 6.0188 7.62146 5.18796 -3.27693 10.2601 -11.1928 +395 1 5.9142 6.93974 5.96821 7.16288 -22.7812 5.828 +396 1 5.1207 7.60724 5.96887 -13.0365 8.36981 -2.80723 +397 1 6.90344 6.91817 5.14994 -0.204819 -5.34708 -0.858742 +398 1 7.6747 7.73724 5.15589 4.74286 -4.17129 0.509029 +399 1 7.64232 6.7419 6.03772 18.4896 23.5989 -0.89996 +400 1 6.75496 7.62762 6.01659 7.03025 5.11039 1.24431 +401 1 0.0963896 0.0201086 6.80553 -1.40648 -0.449972 0.0493894 +402 1 0.835843 0.891839 6.79877 7.20248 -7.32555 0.745706 +403 1 0.918901 8.53581 7.64787 -17.0565 2.54879 17.4592 +404 1 0.0577403 0.896342 7.73471 1.30728 -4.31515 -1.61795 +405 1 1.61051 8.45024 6.92242 29.7484 14.9171 -14.6755 +406 1 2.47578 0.885204 6.88627 1.39053 -1.86497 -2.40181 +407 1 2.50444 0.0274811 7.76899 5.04636 2.83552 -7.66004 +408 1 1.76075 0.832954 7.77629 -9.26653 -0.311946 -7.26081 +409 1 3.50837 8.51457 6.78791 -7.98313 -6.7176 0.868776 +410 1 4.17648 0.757665 6.93195 8.57719 11.9693 -2.56623 +411 1 4.23832 0.0657272 7.77237 -2.00114 -7.83956 -8.62893 +412 1 3.37339 0.86481 7.76894 -4.57993 4.49098 -10.8865 +413 1 5.14407 0.0592801 6.76072 -1.57797 -1.16589 1.03837 +414 1 5.93853 0.879814 6.88423 6.63031 -4.29327 -1.40131 +415 1 6.03919 8.48714 7.63222 -2.96915 1.1039 1.2166 +416 1 5.15255 0.794385 7.73799 -0.425319 2.1861 -1.28188 +417 1 6.89313 0.0918814 6.89086 -1.49841 -3.77335 -3.98868 +418 1 7.61212 0.939213 6.80354 8.77263 -4.1407 2.30253 +419 1 7.70899 8.53849 7.72172 -1.01623 -1.03696 -1.75272 +420 1 6.83169 0.853131 7.69229 0.514071 1.96118 2.47006 +421 1 0.0995377 1.63996 6.92907 -20.9698 6.48021 -16.3567 +422 1 0.856061 2.59196 6.8009 3.6314 -4.45866 -1.95318 +423 1 0.7986 1.79168 7.64825 21.262 -5.45904 12.6361 +424 1 0.086833 2.5674 7.63497 -11.6486 2.30739 1.5806 +425 1 1.65946 1.72494 6.90853 -2.96091 -3.71884 -7.8878 +426 1 2.55175 2.62076 6.77199 1.34599 -1.3093 4.14575 +427 1 2.49264 1.73911 7.61263 5.68035 -0.198489 5.50404 +428 1 1.73023 2.55227 7.60126 -2.61513 6.16936 5.4644 +429 1 3.34887 1.7831 6.78557 0.7181 -0.718938 0.35045 +430 1 4.23104 2.60662 6.78869 6.67274 -5.2978 -0.800832 +431 1 4.35855 1.74494 7.60411 -4.34125 -3.35913 2.62052 +432 1 3.36542 2.60589 7.78048 1.27821 -1.57097 -4.57229 +433 1 5.20004 1.65594 6.83168 -6.03666 5.50106 2.07188 +434 1 5.95504 2.56783 6.93549 0.704503 2.20695 -11.5481 +435 1 6.05448 1.73837 7.6627 -1.83376 -2.83098 2.15288 +436 1 5.1146 2.5438 7.6124 2.3372 -0.290906 4.36925 +437 1 6.88113 1.721 6.77631 -7.16431 5.43568 2.84999 +438 1 7.667 2.62761 6.74793 2.83097 -7.51196 9.4855 +439 1 7.73348 1.72515 7.754 -4.1563 0.657477 -6.03723 +440 1 6.7624 2.63316 7.64937 6.65302 -0.565372 4.94425 +441 1 0.0849859 3.37793 6.84942 -10.0386 4.11872 -3.53604 +442 1 0.857904 4.2895 6.93068 1.24699 0.504054 -2.41984 +443 1 0.822866 3.35005 7.62376 7.62204 5.76535 8.89189 +444 1 0.0609986 4.27823 7.72873 -1.62474 0.278416 -2.41968 +445 1 1.65771 3.45598 6.89789 2.67743 0.0202624 -2.34558 +446 1 2.54508 4.23374 6.86348 0.989961 3.94158 3.39783 +447 1 2.51344 3.50821 7.77131 2.79285 -8.19104 -6.06353 +448 1 1.76675 4.31871 7.74484 -7.62178 -3.47349 -5.94274 +449 1 3.46999 3.3444 6.87805 -6.49672 7.19856 -0.129806 +450 1 4.27761 4.20284 6.7963 2.00695 2.57497 4.55692 +451 1 4.36643 3.33193 7.71738 -5.18938 3.59254 -0.980407 +452 1 3.39117 4.21736 7.78484 2.56803 1.85612 -2.81745 +453 1 5.17851 3.50703 6.80054 -0.562057 -4.69817 1.35476 +454 1 5.91855 4.34694 6.82856 20.1656 -16.4219 -1.68121 +455 1 5.94421 3.41917 7.73472 -0.686701 1.44481 -0.413888 +456 1 5.21752 4.35256 7.70192 -2.57704 -7.73472 4.05334 +457 1 6.81349 3.41173 6.82265 -1.40277 6.3135 5.01717 +458 1 7.75813 4.35693 6.90395 -1.64702 -1.61669 -0.476323 +459 1 7.7614 3.35066 7.72289 -1.59004 1.58238 -2.0122 +460 1 6.90386 4.19648 7.73719 0.143217 3.47184 -3.3084 +461 1 8.51568 5.21538 6.91302 4.27065 -2.85002 -1.50895 +462 1 0.951652 6.01174 6.9207 -11.7991 -7.13131 -18.8927 +463 1 0.936182 5.16144 7.77632 -7.30596 -5.41004 -9.74737 +464 1 0.00163562 6.07485 7.63199 0.624183 -4.07361 5.99132 +465 1 1.66533 5.15284 6.74597 2.96466 -1.56742 2.06772 +466 1 2.61909 5.93515 6.89385 -1.40662 1.18192 -1.24787 +467 1 2.46927 5.13962 7.72554 6.76967 2.2802 -3.81441 +468 1 1.64453 6.02831 7.68681 19.7677 -7.24739 11.5441 +469 1 3.40343 5.06011 6.8889 -0.198511 0.401262 -0.796323 +470 1 4.30752 6.01937 6.85588 -10.789 -11.9311 3.49788 +471 1 4.28416 5.14222 7.62835 0.609452 -0.263512 0.8346 +472 1 3.47645 6.07368 7.70428 -7.22384 -10.7657 -0.906726 +473 1 5.22078 5.0656 6.90915 -18.0053 20.6161 -6.39 +474 1 5.99499 5.93089 6.77083 3.48021 13.0571 15.6598 +475 1 6.05342 5.21794 7.69617 -5.52282 -4.0969 2.40523 +476 1 5.15908 5.93838 7.59985 0.288818 1.34614 5.01043 +477 1 6.82844 5.21514 6.92244 2.6589 -10.3439 -6.80084 +478 1 7.65444 5.90306 6.73997 5.39846 9.09532 17.1635 +479 1 7.73871 5.1328 7.74827 -11.0217 0.411956 -11.9718 +480 1 6.85057 5.9849 7.66627 -2.19779 2.18231 4.19621 +481 1 8.49223 6.85953 6.88515 0.63092 3.61848 -3.8326 +482 1 0.912061 7.72558 6.80554 -14.7372 -15.0451 -0.530208 +483 1 0.94972 6.80465 7.60047 -8.86666 17.9559 7.11774 +484 1 0.0485157 7.69847 7.76952 0.871021 -3.29928 -3.01128 +485 1 1.7395 6.92207 6.74618 -0.216972 -4.99493 2.92958 +486 1 2.48517 7.73307 6.85664 4.02861 0.442708 -0.186237 +487 1 2.60224 6.86957 7.70226 -2.68029 -0.280597 -1.3011 +488 1 1.75659 7.71058 7.78997 -12.217 -12.015 -24.8657 +489 1 3.36601 6.81921 6.83807 2.83617 1.11452 1.50668 +490 1 4.30578 7.6333 6.9198 -11.3388 0.787746 -11.6868 +491 1 4.17656 6.84912 7.75346 9.62737 7.65922 -1.79281 +492 1 3.37828 7.72239 7.62462 0.544776 0.263736 1.68806 +493 1 5.03666 6.75188 6.83201 10.5371 18.8221 7.02157 +494 1 5.88561 7.69892 6.74579 2.44744 2.75196 7.83 +495 1 6.02886 6.89217 7.71335 -1.94107 -2.07696 0.28038 +496 1 5.05253 7.6432 7.63466 10.7152 0.484071 10.517 +497 1 6.76592 6.82276 6.85512 1.71624 -1.12004 -2.46021 +498 1 7.63682 7.73046 6.77254 1.37903 -1.27982 -0.239663 +499 1 7.60482 6.74157 7.76697 8.04118 12.5638 -12.9988 +500 1 6.86424 7.69163 7.60229 0.0588858 0.119654 2.66424 +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +500 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 8.2207069144348992e+00 +0.0000000000000000e+00 8.2207069144348992e+00 +0.0000000000000000e+00 8.2207069144348992e+00 +ITEM: ATOMS id type x y z f_1[1] f_1[2] f_1[3] +1 1 0.0109462 8.19276 8.15872 -2.39444 9.6729 7.55614 +2 1 0.913757 0.79291 0.0997863 -14.8553 6.06953 -19.2131 +3 1 0.922041 0.00329478 0.797424 -4.57303 -13.0314 3.29774 +4 1 0.0667547 0.768895 0.898382 -4.60646 8.57627 -8.38591 +5 1 1.74036 8.13245 0.0766359 -17.8989 17.5469 -5.09772 +6 1 2.47269 0.889925 0.0248853 -5.42566 -21.0007 -17.6291 +7 1 2.46322 8.1233 0.872599 4.75898 11.1097 -4.77186 +8 1 1.65846 0.837491 0.791152 15.1363 -5.40511 14.9864 +9 1 3.32881 8.19546 0.053156 -13.3342 -9.93994 -9.94684 +10 1 4.03279 0.760382 0.00184897 9.91793 7.67217 -5.53917 +11 1 4.13378 8.169 0.732239 -0.574085 -2.22965 11.4349 +12 1 3.20922 0.774467 0.746193 11.6707 -5.4973 20.7036 +13 1 4.84922 8.194 8.14339 7.30804 6.79019 8.16024 +14 1 5.8218 0.772541 8.17358 -10.0231 -1.2549 7.34514 +15 1 5.68256 8.16785 0.77714 3.02512 1.45358 -0.272422 +16 1 4.85759 0.84201 0.746179 4.61671 -0.701957 -1.77598 +17 1 6.62546 8.16087 8.21828 -7.1959 6.90651 13.7327 +18 1 7.47259 0.88807 0.0569708 -4.40901 -2.93179 -3.05075 +19 1 7.47431 0.0411346 0.771198 -11.1102 -3.58532 -4.76152 +20 1 6.57656 0.847149 0.913044 26.339 -17.4997 -36.7448 +21 1 8.18759 1.70398 8.18761 4.1072 -0.492398 0.811998 +22 1 0.899666 2.41042 8.17073 -11.5274 -4.75425 3.68191 +23 1 0.850302 1.72005 0.839978 5.34352 -14.6759 -1.78579 +24 1 0.0603398 2.39798 0.844681 -8.60658 17.5352 -6.64359 +25 1 1.71223 1.59237 0.0242378 -11.0164 14.7761 -6.28233 +26 1 2.39934 2.5183 0.00540478 8.02997 -3.83137 6.03634 +27 1 2.48112 1.56604 0.834626 2.61805 16.1266 0.364368 +28 1 1.6143 2.50502 0.831093 22.9512 -23.9291 -18.4162 +29 1 3.30714 1.5456 0.0352888 3.02185 20.9324 -4.02492 +30 1 4.17998 2.44319 8.21567 -15.5858 -1.30182 -5.2994 +31 1 4.13571 1.72982 0.900024 -11.4398 -17.9409 -9.12775 +32 1 3.31093 2.54257 0.820203 -10.3368 -11.5392 -3.6507 +33 1 5.0044 1.71067 8.16991 -2.52586 -20.2729 12.2321 +34 1 5.83707 2.42978 0.0552544 -9.07217 4.33101 -1.43054 +35 1 5.68958 1.61323 0.87339 20.6627 3.79367 -24.2404 +36 1 4.88712 2.41203 0.783075 18.227 14.4306 8.63131 +37 1 6.51234 1.55641 0.0925838 9.00513 9.77167 -3.15357 +38 1 7.38894 2.55021 8.21638 -3.89162 -5.39246 1.97695 +39 1 7.3932 1.68143 0.910549 14.6159 -16.4356 -32.9418 +40 1 6.52029 2.5195 0.875176 1.21021 -6.27577 -1.18313 +41 1 0.0178952 3.25358 8.17469 3.31384 23.2108 27.1434 +42 1 0.75874 4.10726 8.14569 6.02202 2.9315 8.91628 +43 1 0.895393 3.22207 0.752637 -27.1078 14.1691 0.641871 +44 1 8.18599 4.06691 0.900855 -0.259841 0.495686 -5.35481 +45 1 1.55285 3.22874 8.15747 6.98433 26.3863 8.64396 +46 1 2.49624 4.20319 8.19485 -11.6121 -5.75058 -7.87094 +47 1 2.42547 3.30302 0.888339 10.6882 -12.4594 -2.99107 +48 1 1.6862 4.0108 0.835279 -13.347 15.0654 -7.27246 +49 1 3.22 3.33904 0.0153378 4.70565 -17.4148 -11.2872 +50 1 4.15099 4.01359 0.0472035 -3.25232 -0.128895 -8.82814 +51 1 4.06799 3.24916 0.843927 9.3476 8.05351 2.04714 +52 1 3.19501 4.05 0.736238 12.2088 14.8797 22.981 +53 1 4.93359 3.21205 8.21538 5.02686 8.32666 2.39487 +54 1 5.81852 4.10681 0.0313505 -9.96067 16.6194 -8.35941 +55 1 5.78406 3.36669 0.776887 -2.74739 -9.47942 10.9149 +56 1 4.90983 4.0411 0.864362 0.837356 4.14382 -0.368312 +57 1 6.53897 3.36302 8.19911 9.90234 -20.173 11.5285 +58 1 7.46276 4.04697 0.0534703 -5.76424 1.73449 -3.50806 +59 1 7.34501 3.24442 0.827453 2.34892 5.8087 4.09531 +60 1 6.59021 4.15121 0.905225 -2.44603 -12.1461 -5.89568 +61 1 8.13258 4.93013 0.0905402 6.61239 1.0085 -5.83678 +62 1 0.918786 5.84938 8.18896 -100.34 -125.435 4.75603 +63 1 0.733666 4.90689 0.894865 5.0782 -1.1493 -19.9038 +64 1 8.13743 5.78012 0.885656 21.4143 -27.2006 -30.8387 +65 1 1.67225 4.91657 0.0765019 -6.36422 -5.41993 -9.68754 +66 1 2.43163 5.74665 8.16344 0.0454169 7.36314 0.282499 +67 1 2.52248 4.94902 0.779546 -17.0632 -3.92502 5.40756 +68 1 1.68817 5.73221 0.738326 -10.7061 -22.6586 25.0306 +69 1 3.20519 4.98792 8.20267 13.0471 -20.6699 18.764 +70 1 4.1645 5.8475 0.0144516 -41.0284 -51.2746 -22.2701 +71 1 4.12065 4.85332 0.726813 -6.7392 5.54296 9.04283 +72 1 3.22358 5.72978 0.902951 13.2902 6.38408 -11.6219 +73 1 4.86923 4.9681 8.18768 10.2044 -1.77915 -2.81852 +74 1 5.77301 5.70687 8.13281 -22.5863 16.9623 33.7246 +75 1 5.78731 4.97674 0.770243 -6.25016 -2.29075 -2.78772 +76 1 4.89256 5.78932 0.733037 29.9716 -43.8231 39.093 +77 1 6.61696 5.02048 8.19969 -11.3595 -28.891 -1.36328 +78 1 7.33645 5.74186 0.0277988 27.1444 12.1113 -11.7126 +79 1 7.32557 4.92161 0.798933 6.38759 1.63603 8.88722 +80 1 6.60198 5.76847 0.724174 -12.087 6.06842 22.1567 +81 1 0.0632305 6.4911 0.00261304 -6.53376 9.85675 7.22968 +82 1 0.730752 7.3973 8.19101 19.8665 -4.89129 14.6872 +83 1 0.894205 6.53954 0.906348 -15.672 -5.70878 -18.8817 +84 1 0.0916376 7.35116 0.914882 -39.3163 -12.8553 -54.9509 +85 1 1.54844 6.4779 0.0899714 109.204 121.919 -0.90408 +86 1 2.45374 7.43343 8.1677 17.1682 -16.9212 2.53497 +87 1 2.38485 6.48495 0.871503 16.8711 24.0952 -19.5071 +88 1 1.73482 7.30198 0.918245 -4.50526 25.4363 -21.6583 +89 1 3.35837 6.52948 0.00621289 -17.9347 4.05163 8.57797 +90 1 4.15544 7.30314 8.17418 -3.86421 14.3399 10.028 +91 1 4.18078 6.49797 0.807337 -33.0181 25.5019 29.3461 +92 1 3.28881 7.33369 0.840128 0.0678552 -0.60668 -1.16807 +93 1 4.86711 6.50097 0.0644243 55.2704 56.5162 -42.5456 +94 1 5.6807 7.37537 8.15497 2.37339 1.6253 6.06405 +95 1 5.83906 6.54647 0.813774 -8.31017 -0.439493 -0.862375 +96 1 4.90102 7.33548 0.785855 3.38301 3.17369 4.3776 +97 1 6.62594 6.60016 8.16507 -28.5529 -10.5165 29.461 +98 1 7.41236 7.32596 8.18119 12.8158 16.6867 22.5272 +99 1 7.48788 6.57526 0.906715 -17.6408 15.7915 -12.9219 +100 1 6.60846 7.32088 0.891813 -2.23221 1.45701 -6.99196 +101 1 8.17 8.13088 1.54543 21.7946 28.0076 23.7334 +102 1 0.889634 0.755106 1.5647 -2.22366 9.82139 12.4406 +103 1 0.787312 0.00367743 2.47285 9.7959 7.14049 -7.07183 +104 1 0.0399172 0.910289 2.54829 -10.4426 -54.7685 -48.8923 +105 1 1.70161 0.076186 1.70291 0.655659 -5.9987 -1.53887 +106 1 2.5425 0.840944 1.65312 -5.39214 -2.71573 1.42057 +107 1 2.39333 0.0846015 2.56412 19.1459 -13.6703 -26.8796 +108 1 1.62991 0.895915 2.55976 -9.37186 -8.23605 -42.2796 +109 1 3.3255 0.037006 1.60354 -4.30714 4.73223 -3.06839 +110 1 4.20236 0.841896 1.65063 -10.9567 4.39501 -2.76043 +111 1 4.12511 8.16508 2.38147 6.48597 31.2032 29.2026 +112 1 3.37125 0.822661 2.38548 -3.89508 0.169143 6.57094 +113 1 4.86677 0.028066 1.55007 9.3902 -7.55136 2.71818 +114 1 5.8528 0.805894 1.56988 -29.5994 -6.3857 29.2326 +115 1 5.73944 8.2048 2.38025 -0.334985 15.3443 16.2286 +116 1 4.92058 0.739392 2.48512 1.8123 5.57771 -0.399822 +117 1 6.61747 8.14877 1.63757 -7.92973 14.3058 -0.0863647 +118 1 7.37923 0.805843 1.70616 17.0436 -4.06349 -13.2175 +119 1 7.38533 8.17909 2.55221 2.10247 4.05286 -21.3656 +120 1 6.66981 0.91359 2.42776 -18.0385 -1.7859 9.16667 +121 1 8.21433 1.71804 1.64878 9.58557 -8.70073 -6.06848 +122 1 0.91795 2.50647 1.62107 -49.2165 -42.2319 12.3144 +123 1 0.778719 1.62612 2.3667 15.8366 8.16624 0.723179 +124 1 0.0388825 2.56454 2.43408 -0.65123 -11.9302 4.78295 +125 1 1.70614 1.64161 1.56714 -4.83448 1.54656 8.88708 +126 1 2.55772 2.51525 1.68348 -33.0305 -26.0768 -4.05159 +127 1 2.46774 1.68666 2.4295 -0.728639 -2.90689 1.14987 +128 1 1.58495 2.48207 2.53043 32.1395 -14.2129 -42.8967 +129 1 3.28639 1.69638 1.58862 0.141668 -5.07807 4.69228 +130 1 4.07581 2.46356 1.66204 5.75617 5.24573 6.028 +131 1 4.09064 1.65395 2.45941 5.06207 -1.15698 -3.64398 +132 1 3.2978 2.42597 2.51229 -0.392826 8.06961 -8.70923 +133 1 4.99952 1.60143 1.58928 -25.5713 -7.8385 22.8567 +134 1 5.66634 2.3835 1.71386 21.3679 17.6667 -19.1597 +135 1 5.74656 1.70527 2.50917 3.11288 -14.4009 7.07914 +136 1 4.97163 2.46224 2.45828 -14.3686 2.77193 11.4917 +137 1 6.62989 1.62285 1.56611 -20.0211 14.8617 27.1541 +138 1 7.37036 2.42163 1.58976 1.23932 26.194 15.084 +139 1 7.49234 1.71782 2.38524 -11.5645 -3.14792 16.0927 +140 1 6.57493 2.44646 2.50738 3.76278 -0.484364 -1.65815 +141 1 8.13855 3.28395 1.66364 9.95915 -4.6352 -13.1677 +142 1 0.822632 4.13968 1.61013 -1.66869 -18.1546 6.90643 +143 1 0.836195 3.27368 2.50106 -4.0013 3.27813 -2.23185 +144 1 0.00706469 4.04664 2.42415 6.78153 4.66429 11.0832 +145 1 1.56864 3.19926 1.57501 43.2252 54.2341 22.2486 +146 1 2.37435 4.19613 1.65007 19.5365 -23.6872 -5.11708 +147 1 2.53204 3.33272 2.45976 -10.1616 -1.37273 8.96239 +148 1 1.5958 4.02298 2.45513 4.44558 4.83545 -0.957126 +149 1 3.24862 3.20562 1.71329 33.7169 30.1535 -8.86948 +150 1 4.04966 4.11271 1.69147 14.455 0.133261 -16.0308 +151 1 4.17313 3.29199 2.42566 -5.80506 -5.3643 5.35172 +152 1 3.37886 4.04594 2.4591 -12.864 4.86539 14.8631 +153 1 5.00029 3.3715 1.7428 -16.124 -51.6521 -51.6846 +154 1 5.71525 4.10565 1.71106 18.126 11.5713 -25.6554 +155 1 5.67368 3.37853 2.52254 40.5036 -38.7002 16.4445 +156 1 4.98188 4.047 2.42098 -44.4942 70.6847 47.3189 +157 1 6.52567 3.216 1.71371 -0.385424 4.96723 -0.762826 +158 1 7.40007 4.08176 1.73877 -6.32286 -1.56827 -20.7524 +159 1 7.42837 3.30042 2.4503 -10.1629 -6.83382 9.16894 +160 1 6.52178 4.09551 2.40152 8.21405 -5.0269 3.15343 +161 1 0.00699263 4.85762 1.69229 -17.0824 5.05692 -6.94595 +162 1 0.756152 5.6631 1.60232 14.3979 15.6472 -4.59775 +163 1 0.764682 4.99903 2.39299 18.2885 -21.5851 21.4239 +164 1 0.0800264 5.75765 2.41619 -22.1201 11.2764 3.26076 +165 1 1.60226 4.84293 1.69094 -9.96687 23.2298 -5.36928 +166 1 2.38001 5.77059 1.56073 -4.13582 -26.0328 27.2432 +167 1 2.39304 4.87599 2.45449 3.86796 9.40324 7.0282 +168 1 1.5595 5.8443 2.45554 15.3251 -19.3503 -10.1983 +169 1 3.24805 4.8639 1.55208 5.72697 0.833939 9.91621 +170 1 4.12523 5.83768 1.72183 2.66681 -7.18069 -9.93584 +171 1 4.14719 4.98927 2.48442 -5.36599 -4.29088 6.08995 +172 1 3.29103 5.75037 2.41213 -9.14312 -21.8308 11.1485 +173 1 4.88531 4.96658 1.71552 5.62499 -3.03462 -8.19539 +174 1 5.80164 5.66001 1.66617 -22.0309 23.7646 0.752493 +175 1 5.79599 4.88622 2.4436 -18.3543 9.31939 -6.6266 +176 1 4.94007 5.78406 2.4889 7.47518 -6.1933 -6.95152 +177 1 6.50282 4.96059 1.57437 23.9581 -12.4339 8.07292 +178 1 7.43162 5.77666 1.60532 -16.9632 -9.02864 21.2089 +179 1 7.30902 4.88901 2.38072 1.39073 12.4251 10.603 +180 1 6.52191 5.81931 2.5443 7.19321 -57.902 -45.2674 +181 1 0.0825324 6.49799 1.58172 -0.0568703 17.3702 26.5223 +182 1 0.807327 7.40344 1.54436 38.413 9.53604 44.8678 +183 1 0.85313 6.5885 2.46372 -17.206 13.7674 -10.0743 +184 1 0.0766958 7.42441 2.49843 -14.0409 -5.69227 -10.6889 +185 1 1.56626 6.64679 1.65111 17.2201 -21.881 29.7832 +186 1 2.51758 7.48828 1.7101 -1.12703 -9.37355 7.34939 +187 1 2.48642 6.48139 2.37761 -17.45 9.10758 18.4987 +188 1 1.62607 7.39059 2.4668 5.47881 2.11068 -4.08662 +189 1 3.22096 6.48273 1.68127 15.0894 18.1205 -19.6751 +190 1 4.01435 7.47003 1.70259 9.92584 -36.0532 -31.9009 +191 1 4.01053 6.48307 2.56537 4.58494 43.5966 -38.8488 +192 1 3.31708 7.46346 2.49246 -11.1632 -6.704 4.9273 +193 1 4.97912 6.56412 1.70872 -0.0323444 1.40088 -5.51009 +194 1 5.76314 7.42951 1.73429 -4.71194 -18.4847 -18.3917 +195 1 5.75053 6.57569 2.52583 -15.5416 2.95473 -19.9489 +196 1 4.86788 7.33538 2.51839 21.348 1.25465 -21.9702 +197 1 6.54919 6.48383 1.72129 1.36669 8.74928 -8.3147 +198 1 7.40692 7.48075 1.59274 -4.17636 -24.5364 8.08039 +199 1 7.31105 6.49008 2.55841 18.9084 8.98379 -5.81349 +200 1 6.56124 7.4093 2.46898 3.88266 -3.866 3.64736 +201 1 0.0467578 0.0587236 3.25639 -2.58837 -3.06001 8.14477 +202 1 0.919472 0.840587 3.2901 -13.7955 -3.94396 11.0802 +203 1 0.913851 8.17129 4.10222 -17.0314 2.36091 -15.061 +204 1 8.12452 0.831674 4.11824 2.96137 1.66258 0.705395 +205 1 1.72266 8.12268 3.2983 -16.5809 -0.000561518 15.0322 +206 1 2.36681 0.848699 3.23189 33.3023 -3.20785 26.2082 +207 1 2.52451 0.093755 4.0501 -20.4816 -4.23237 16.7496 +208 1 1.57332 0.89934 4.17862 1.65408 -10.4059 -4.79402 +209 1 3.23411 8.18086 3.33998 20.9401 7.85353 -15.8307 +210 1 4.12777 0.912462 3.28751 -3.54395 -8.15241 -0.704223 +211 1 4.05479 8.16789 4.17086 6.43266 7.42359 -18.6916 +212 1 3.3412 0.763098 4.14988 -8.17365 16.5822 -19.2151 +213 1 4.85923 8.19378 3.30398 3.75427 6.29815 -1.39384 +214 1 5.723 0.836221 3.31262 4.07436 -7.7371 -12.3645 +215 1 5.78765 0.0695661 4.10746 2.41957 -4.40965 -1.14115 +216 1 4.97909 0.892899 4.12401 -13.5931 -16.8127 1.66952 +217 1 6.57108 0.0657357 3.30807 -10.4223 -10.045 -0.47006 +218 1 7.35373 0.738008 3.24493 15.9915 16.7978 9.43624 +219 1 7.34677 0.0332152 4.15763 12.3358 5.5849 -5.20193 +220 1 6.67147 0.918341 4.12524 -9.23951 -11.4667 0.577623 +221 1 0.0788919 1.58016 3.21314 -1.55258 49.5779 50.5391 +222 1 0.904188 2.40885 3.22233 -31.0956 -2.82504 30.7646 +223 1 0.877149 1.74225 4.15165 7.55452 -10.7555 -4.03202 +224 1 0.0936835 2.40444 4.16194 -19.0736 7.56858 -3.47745 +225 1 1.71236 1.61805 3.29179 -19.7602 28.7111 2.45155 +226 1 2.5486 2.41776 3.31547 -43.6679 25.9149 -16.2942 +227 1 2.39734 1.55251 4.06577 15.8032 7.53109 12.4652 +228 1 1.72237 2.5181 4.15876 -10.7679 -10.2774 -3.05137 +229 1 3.23039 1.71099 3.29502 25.8646 -44.0791 -9.55739 +230 1 4.12827 2.45813 3.1934 -6.48806 -10.3202 8.62038 +231 1 4.19407 1.63495 4.09603 -15.4993 6.39445 10.1662 +232 1 3.20761 2.36838 4.07177 19.5744 11.0493 29.9438 +233 1 4.94979 1.63514 3.37535 1.21152 5.67416 -27.5114 +234 1 5.82776 2.47766 3.34313 -3.66364 1.42568 -1.20833 +235 1 5.76542 1.58538 4.03513 14.4098 19.4192 12.2978 +236 1 4.95489 2.43394 4.07273 -1.13246 5.06376 7.36624 +237 1 6.661 1.60077 3.30919 -3.43354 8.94885 -5.94598 +238 1 7.49515 2.56092 3.28033 -10.5336 -12.2625 1.51454 +239 1 7.39275 1.71767 4.16117 3.5537 3.96098 0.811537 +240 1 6.54244 2.56469 4.20941 11.0399 -32.6669 -26.4629 +241 1 8.2116 3.30444 3.37137 5.74747 4.63382 -14.2394 +242 1 0.840624 4.14226 3.27407 -5.48884 -5.61804 0.498093 +243 1 0.734437 3.23139 4.08576 22.8281 5.93798 4.2063 +244 1 0.0471721 4.13123 4.11158 -4.3827 3.27424 0.087671 +245 1 1.70286 3.20807 3.23042 -2.96775 14.0769 10.9943 +246 1 2.38769 4.13105 3.27446 4.88078 -2.82576 -1.60425 +247 1 2.4087 3.28686 4.02353 16.6104 0.201322 7.1777 +248 1 1.69983 4.0678 4.13415 -10.6977 3.91895 2.19645 +249 1 3.34377 3.23634 3.36851 -11.3528 1.51526 -17.2895 +250 1 4.2055 4.03294 3.37597 -23.3492 5.34016 -26.85 +251 1 4.03955 3.26203 4.11941 11.7033 -4.94552 16.1773 +252 1 3.21963 4.01243 4.16102 5.66091 6.82551 -5.40832 +253 1 4.83261 3.19517 3.32313 20.1816 8.52525 -2.26656 +254 1 5.77148 4.16495 3.28824 -31.489 -26.7787 -6.90732 +255 1 5.82425 3.30115 4.19401 -37.1473 -6.40083 -11.3511 +256 1 4.87724 4.09609 4.11549 36.2568 -10.3151 3.06059 +257 1 6.58329 3.33973 3.22197 0.0461967 -7.66729 -2.40242 +258 1 7.43644 4.05966 3.30265 -3.56999 5.92726 -1.37248 +259 1 7.48286 3.29775 4.19646 -3.89008 -9.4431 -11.0777 +260 1 6.47907 4.03353 4.01383 29.8324 22.3851 15.73 +261 1 8.15241 5.02846 3.31122 10.6595 -5.28085 -5.36552 +262 1 0.804631 5.8376 3.20576 13.4276 -32.1322 14.0647 +263 1 0.877129 4.8969 4.13251 -1.47043 5.42126 -0.0257482 +264 1 0.0651636 5.75976 4.1954 -9.31697 -6.72952 -15.907 +265 1 1.57617 4.92532 3.28718 5.51341 5.68743 -3.59864 +266 1 2.42583 5.72219 3.30114 4.35376 1.25963 -4.44713 +267 1 2.4551 4.89394 4.08913 0.180251 2.9051 2.6698 +268 1 1.67099 5.80732 4.08057 -5.18981 -1.73911 5.86888 +269 1 3.33413 4.84944 3.32334 -2.55875 1.02427 -1.99572 +270 1 4.20493 5.83452 3.24979 -21.4386 -63.3893 34.6056 +271 1 4.19181 4.8901 4.01924 -15.0952 14.1984 13.5631 +272 1 3.36551 5.83759 4.08786 -9.40985 -16.2604 3.57159 +273 1 4.9921 4.89151 3.36329 -7.1819 8.21085 -25.7306 +274 1 5.77026 5.74279 3.2372 -19.2661 -13.3988 15.8911 +275 1 5.68576 4.90444 4.10854 12.1482 9.27276 4.35592 +276 1 4.84395 5.80423 4.20869 23.9245 -11.025 -23.296 +277 1 6.4858 4.83859 3.18898 36.5327 24.7135 15.3623 +278 1 7.30315 5.68446 3.36881 -0.385614 18.5722 -20.0571 +279 1 7.37309 4.9455 4.05168 -2.3203 -17.2743 20.9328 +280 1 6.63896 5.83294 4.18727 -7.1922 -10.1498 -0.517575 +281 1 0.0942908 6.52233 3.3159 -35.7657 14.4096 -15.937 +282 1 0.836387 7.40457 3.20726 4.47284 -0.4112 17.4557 +283 1 0.739312 6.64758 4.08638 39.4722 -18.3951 12.5032 +284 1 8.21631 7.30153 4.06221 -15.2581 27.9702 -0.672668 +285 1 1.58758 6.54973 3.25882 10.9016 11.7867 8.01769 +286 1 2.56536 7.3619 3.34369 -76.1678 6.55793 -73.9603 +287 1 2.52556 6.61112 4.10224 -30.5256 -34.6487 7.0656 +288 1 1.62124 7.32393 4.18622 0.536802 -1.56833 -6.92191 +289 1 3.3681 6.64037 3.37818 -8.53205 -51.1792 -62.7851 +290 1 4.15298 7.36163 3.20593 -21.9528 4.612 22.3686 +291 1 4.12464 6.54108 4.035 14.4356 20.1369 22.2034 +292 1 3.19906 7.31073 4.01315 82.3215 73.9575 117.35 +293 1 4.9065 6.52075 3.26638 28.3768 26.425 6.32862 +294 1 5.74138 7.36096 3.25092 -0.970474 8.69807 4.03129 +295 1 5.81652 6.58456 4.03756 -14.737 -0.580193 0.741413 +296 1 4.87586 7.39212 4.03191 6.20313 -4.00572 5.92319 +297 1 6.48611 6.49412 3.21889 20.5434 47.1119 52.8917 +298 1 7.41876 7.4098 3.23912 -0.409624 -8.77258 11.2401 +299 1 7.35972 6.63444 4.07034 1.58562 -5.33459 -2.2315 +300 1 6.64271 7.48657 4.18074 -12.6903 -3.8877 -6.90745 +301 1 8.18545 0.00495327 4.98201 0.835961 10.4978 -8.83054 +302 1 0.830861 0.760813 4.98094 -9.95647 8.66756 -7.1447 +303 1 0.808969 0.00641337 5.74397 -4.48252 1.30502 4.67537 +304 1 0.018812 0.795135 5.84676 0.988121 0.902183 -11.1018 +305 1 1.60862 0.0119183 4.84308 17.0508 -2.91068 17.4808 +306 1 2.50239 0.876955 4.96833 -9.09304 -5.08176 -4.69214 +307 1 2.44832 8.14323 5.81234 6.77585 9.13889 -19.0494 +308 1 1.56911 0.731109 5.75394 17.4698 11.7404 -4.99849 +309 1 3.28793 0.0458368 4.91142 -7.08209 -9.95818 14.0315 +310 1 4.07208 0.823519 4.87126 26.6153 -9.6486 13.2451 +311 1 4.06672 0.0477209 5.80002 10.3282 0.566915 -15.466 +312 1 3.2042 0.88056 5.78404 3.8932 -8.75566 -1.61055 +313 1 5.02696 0.0222739 4.88991 -12.0715 4.27124 3.2294 +314 1 5.73734 0.886325 4.85298 9.71713 -6.59089 13.6933 +315 1 5.79543 0.0389128 5.76135 -3.4407 3.92019 -0.496418 +316 1 4.85161 0.780997 5.82861 2.47749 38.2945 -34.2513 +317 1 6.64858 0.0906911 4.97808 -13.982 -18.784 -13.0607 +318 1 7.30429 0.900733 5.00382 63.7384 -13.5798 -32.445 +319 1 7.4114 8.15633 5.76261 6.64498 1.40027 -2.33346 +320 1 6.66824 0.783026 5.72649 -29.5414 5.85716 47.7215 +321 1 0.0281683 1.66949 4.95949 -0.425666 -3.96058 2.91208 +322 1 0.893447 2.47998 4.9969 -1.93266 1.10148 -5.4469 +323 1 0.843715 1.6221 5.7589 -0.766033 4.56211 -3.21682 +324 1 0.0782454 2.53663 5.73256 -1.35265 -11.3593 -4.90859 +325 1 1.65079 1.66704 4.93767 -0.533365 0.139965 4.11876 +326 1 2.51601 2.38441 4.90805 0.649871 6.98133 -0.140965 +327 1 2.41175 1.72195 5.72474 2.84663 -8.86686 7.73621 +328 1 1.61538 2.54316 5.81674 -0.089029 -19.7728 -12.4678 +329 1 3.35891 1.54703 4.95536 -9.48818 22.4331 -2.56554 +330 1 4.08195 2.54313 5.01426 16.1748 -2.70068 -21.0768 +331 1 4.12034 1.74262 5.81366 10.5637 -13.2904 -3.74489 +332 1 3.37175 2.4672 5.72729 -31.5422 -3.32565 13.6818 +333 1 5.0033 1.68848 4.95948 -13.0392 -13.8401 -3.80319 +334 1 5.66589 2.47997 4.89515 25.4212 2.24436 -8.70857 +335 1 5.79028 1.55903 5.82666 2.05757 18.2253 -24.3713 +336 1 5.0311 2.46113 5.68951 -16.9377 1.04 21.5338 +337 1 6.57827 1.56896 5.01204 -21.5711 32.5342 -4.2816 +338 1 7.31623 2.52382 4.98258 18.6955 -8.52314 -2.25127 +339 1 7.45461 1.64332 5.76278 -16.0261 1.47893 -16.982 +340 1 6.64089 2.42957 5.78128 -11.0128 0.688597 0.00936653 +341 1 0.0932375 3.33117 4.94446 -5.57952 -6.38154 1.87127 +342 1 0.757472 4.19176 4.95128 10.4651 -6.09524 -1.36969 +343 1 0.907905 3.31127 5.7437 -27.4593 -10.6172 -1.55436 +344 1 0.042027 4.05791 5.75958 -12.212 5.31553 -4.25834 +345 1 1.73758 3.25237 5.02547 -7.72352 0.251809 -15.9993 +346 1 2.4871 4.0191 4.9543 -17.108 24.4302 2.09179 +347 1 2.45668 3.23081 5.78465 2.15315 9.79763 4.28788 +348 1 1.58106 4.05092 5.80356 25.1427 18.6418 -4.49313 +349 1 3.19249 3.31456 5.03239 24.0259 -22.2006 -10.8088 +350 1 4.20707 4.15779 4.866 -22.1265 -5.11578 15.6203 +351 1 4.10653 3.22389 5.85277 -11.4198 11.552 -29.8203 +352 1 3.32529 4.01575 5.8236 -9.29377 10.539 -6.33768 +353 1 5.02426 3.35158 5.01899 -31.0395 -2.45923 -24.1365 +354 1 5.68644 4.17189 4.85403 7.36649 -6.63658 10.5871 +355 1 5.74132 3.29275 5.69662 23.2126 4.63385 22.4488 +356 1 4.92531 4.19073 5.71088 -1.56015 -9.54037 12.8094 +357 1 6.54444 3.23385 4.93781 3.72392 28.1796 29.5331 +358 1 7.41233 4.02229 4.92924 -1.20364 12.0626 9.54412 +359 1 7.4663 3.28529 5.82942 -29.7597 -4.87929 -37.7444 +360 1 6.60644 4.05138 5.75927 -5.95188 5.2753 -7.63938 +361 1 8.20344 4.97671 5.0085 -9.77785 -27.0171 -16.098 +362 1 0.764125 5.65629 4.97235 19.2848 26.171 -13.514 +363 1 0.873777 4.9677 5.68286 -0.798932 -14.5746 27.2238 +364 1 8.1297 5.72693 5.67887 36.2224 14.0656 51.1647 +365 1 1.7318 5.02959 5.01529 -5.49043 -14.6131 -16.8314 +366 1 2.44542 5.85219 4.93063 19.3822 -11.3762 -19.1618 +367 1 2.55143 4.96012 5.6972 2.49476 -2.70049 4.14057 +368 1 1.7425 5.82205 5.68004 -17.6493 -28.263 45.9708 +369 1 3.3219 4.92271 4.83646 -0.36054 0.182371 1.57441 +370 1 4.15401 5.67616 4.9285 -21.3575 6.09757 11.4691 +371 1 4.07715 4.94174 5.74451 -0.595544 -7.12056 -1.40506 +372 1 3.31639 5.79418 5.70206 -6.4923 -7.4901 3.07645 +373 1 4.92581 4.94202 4.97984 -0.22012 5.90431 -14.5879 +374 1 5.73821 5.69855 4.88283 0.98112 8.81137 -0.251897 +375 1 5.70683 4.9474 5.70386 9.48927 0.653977 8.8924 +376 1 4.96412 5.79635 5.67508 -8.29845 -17.1654 19.2091 +377 1 6.48765 4.91573 4.91811 9.87445 -1.02048 -0.929801 +378 1 7.42803 5.76565 5.01887 -36.8924 9.29378 -39.8178 +379 1 7.31535 5.01349 5.75729 -2.96639 -15.6116 3.19898 +380 1 6.51112 5.80276 5.76292 -0.511839 0.0343249 -1.86567 +381 1 0.0752499 6.50198 4.93503 -9.95853 14.5519 3.18185 +382 1 0.749032 7.44313 4.93057 9.36322 -4.26106 -6.17112 +383 1 0.799308 6.59761 5.72007 7.23025 -2.947 1.48543 +384 1 0.0646916 7.47006 5.72188 -15.7332 -12.5303 9.25543 +385 1 1.64476 6.54961 5.03014 -20.9538 30.4927 -38.3434 +386 1 2.45435 7.39325 4.88002 3.42796 3.8663 5.03137 +387 1 2.4342 6.59097 5.67369 23.2905 17.249 22.0616 +388 1 1.54778 7.4679 5.8363 19.3115 -12.9738 -21.1698 +389 1 3.32159 6.57391 4.94635 0.920374 5.37222 -4.76541 +390 1 4.12734 7.43087 4.87631 0.0949958 -12.9619 14.1535 +391 1 4.03648 6.57336 5.82487 9.67898 -2.57585 -4.33725 +392 1 3.37401 7.44443 5.83215 -8.90767 -10.0262 -16.7558 +393 1 4.95785 6.5313 4.96795 -5.28369 20.3288 -12.6073 +394 1 5.72446 7.44815 4.95617 -0.295615 -4.81227 -6.28599 +395 1 5.67507 6.56368 5.75557 19.5363 2.36566 3.12879 +396 1 4.99604 7.36578 5.82253 -12.0795 7.56208 -16.0156 +397 1 6.47952 6.65183 4.84549 7.81673 -1.192 17.7565 +398 1 7.49045 7.38842 4.86267 -3.31154 -1.72952 10.3926 +399 1 7.31515 6.64393 5.7627 1.65473 -7.46902 -9.80451 +400 1 6.51213 7.44705 5.67942 6.88055 -5.46286 6.12471 +401 1 0.0806264 0.0886591 6.67061 2.86389 -53.8636 -44.0246 +402 1 0.883633 0.899989 6.55658 -11.6958 -11.9156 5.39561 +403 1 0.88757 0.0447352 7.4623 -6.5852 -8.63148 -1.54458 +404 1 0.00589996 0.782701 7.30583 -3.57511 51.2033 48.3924 +405 1 1.70878 0.0185969 6.53425 -9.91562 -0.171369 19.1044 +406 1 2.47179 0.820184 6.65916 -10.0875 0.778119 -25.3377 +407 1 2.53937 0.0160974 7.34796 -3.95783 -6.52463 5.98309 +408 1 1.62994 0.765044 7.35659 9.0133 10.535 7.11032 +409 1 3.30704 0.041501 6.48376 -12.5346 2.59741 23.4233 +410 1 4.02443 0.849646 6.63591 28.9911 -27.1685 -8.99322 +411 1 4.05271 0.0416361 7.37632 0.533135 -1.75778 -2.17869 +412 1 3.19386 0.898466 7.37702 15.4736 -11.3366 18.5812 +413 1 4.93306 0.0872445 6.49555 4.8751 -33.7979 36.6921 +414 1 5.84884 0.883258 6.55834 -5.60524 -28.829 17.1111 +415 1 5.81564 0.024621 7.40384 -2.36039 -5.56484 -6.47242 +416 1 4.961 0.816895 7.40894 -1.64345 1.03662 -2.05135 +417 1 6.67176 0.000709987 6.50931 -8.49107 -0.789231 11.0199 +418 1 7.42872 0.868407 6.55728 -5.95092 -10.3429 1.39671 +419 1 7.36138 8.18623 7.46478 9.04825 4.48366 -10.7424 +420 1 6.59985 0.825831 7.39669 4.88737 -2.34866 2.27965 +421 1 8.14416 1.67759 6.49013 32.825 -1.32457 17.7447 +422 1 0.9037 2.40379 6.60352 -22.6991 13.3728 -5.6252 +423 1 0.83815 1.6821 7.34463 -6.45777 -9.82884 14.5288 +424 1 8.19206 2.55987 7.48041 1.09967 -24.6646 -31.5822 +425 1 1.61029 1.6565 6.61062 19.3859 -4.50632 -8.40911 +426 1 2.39042 2.47779 6.49991 10.3869 -7.14038 20.8685 +427 1 2.43336 1.66264 7.31159 -0.298923 7.67874 9.60508 +428 1 1.68521 2.53757 7.43341 0.0908995 -20.3899 -19.4953 +429 1 3.34574 1.55658 6.57542 -29.1499 40.141 -5.99747 +430 1 4.09567 2.50385 6.58715 2.92988 -17.1157 8.90269 +431 1 4.06967 1.60141 7.36073 8.28003 9.68724 13.2999 +432 1 3.26291 2.44686 7.41755 -1.72761 -1.27824 0.484775 +433 1 5.02343 1.63061 6.57358 -10.9076 3.24904 2.06921 +434 1 5.8117 2.52535 6.48584 -2.10788 -3.23133 8.48842 +435 1 5.76381 1.64883 7.37339 7.06147 -0.584215 3.21917 +436 1 4.99697 2.44099 7.45915 -1.75923 11.2498 -19.4182 +437 1 6.62044 1.59458 6.63611 -5.65576 11.9066 -13.6974 +438 1 7.40085 2.40641 6.52565 -4.26631 17.0681 5.6259 +439 1 7.4086 1.68173 7.30269 7.67403 -2.22025 20.1658 +440 1 6.56414 2.4958 7.48155 2.02857 -0.65966 -9.40352 +441 1 8.16172 3.22 6.50779 31.0613 6.17733 37.0029 +442 1 0.778923 4.13348 6.47989 7.10682 -1.13444 17.3069 +443 1 0.731543 3.38344 7.32104 8.57141 -10.8353 -0.596329 +444 1 8.20703 4.11651 7.39737 -10.5501 6.3503 -2.89453 +445 1 1.5556 3.22612 6.62242 10.8567 18.3759 1.80723 +446 1 2.43596 4.07218 6.65191 19.5996 1.93234 -23.7547 +447 1 2.42128 3.38357 7.48855 6.46322 -13.7769 -4.42002 +448 1 1.70183 4.1306 7.3251 -28.6202 8.98318 18.3174 +449 1 3.23368 3.21004 6.55845 -1.66335 0.810928 5.98502 +450 1 4.02817 4.01745 6.59179 9.73332 14.3603 -1.234 +451 1 4.04024 3.24371 7.33596 9.19519 -2.61436 13.2612 +452 1 3.33578 4.03204 7.3761 -11.8519 11.1256 7.31388 +453 1 4.84615 3.34919 6.50516 30.474 -3.21025 16.5113 +454 1 5.79338 4.10407 6.63223 -1.4488 4.34379 -6.9657 +455 1 5.71769 3.33306 7.36343 3.56485 -8.31237 5.17357 +456 1 4.89884 4.06687 7.36632 1.94898 -1.38193 2.81677 +457 1 6.61297 3.34048 6.58436 -38.9416 -40.8203 -5.50523 +458 1 7.30794 4.01061 6.56591 40.2005 61.5018 -17.6954 +459 1 7.37741 3.36957 7.31145 38.0889 -52.6112 27.9446 +460 1 6.66665 4.01974 7.42717 -35.3166 42.1921 1.19147 +461 1 0.0452175 4.90338 6.62118 -6.71352 5.92623 -3.01906 +462 1 0.869367 5.66645 6.62279 -29.6122 19.3042 -24.6336 +463 1 0.858776 5.03104 7.45654 -16.814 -24.2615 8.51744 +464 1 8.14658 5.74936 7.4724 2.5583 -5.40279 -7.71149 +465 1 1.59957 4.95319 6.53572 14.873 -15.6204 -6.12191 +466 1 2.54529 5.66468 6.59785 -23.4011 43.3591 -27.461 +467 1 2.4961 5.03005 7.34302 -11.668 -32.1864 28.6337 +468 1 1.60544 5.69113 7.30132 37.8442 13.2739 23.8753 +469 1 3.24356 4.96073 6.59142 26.8133 -25.0989 -5.08933 +470 1 4.09781 5.67439 6.52285 2.63557 7.15813 7.05447 +471 1 4.18105 4.86276 7.35501 -9.07005 4.72655 -1.53462 +472 1 3.36767 5.65499 7.49749 6.09099 26.0319 -27.9028 +473 1 5.01795 4.94278 6.59504 -2.00637 0.995546 -1.6799 +474 1 5.7841 5.85399 6.63871 4.06216 -12.0086 -14.5693 +475 1 5.83404 5.02565 7.38856 -29.8707 -40.8918 -9.03319 +476 1 4.9605 5.83878 7.31445 -12.603 -27.5006 25.6094 +477 1 6.59477 4.88222 6.67554 -4.07568 1.88148 -17.9737 +478 1 7.35313 5.77701 6.52551 0.181186 3.4052 7.13046 +479 1 7.348 4.89641 7.37973 13.5892 1.99375 8.82978 +480 1 6.49663 5.74982 7.4422 46.6685 29.9241 -18.7201 +481 1 0.0491078 6.53098 6.47716 -5.83531 -0.141054 6.60445 +482 1 0.791488 7.40292 6.50563 -8.70546 -0.874788 22.49 +483 1 0.919931 6.51323 7.45776 -11.5314 25.4002 -28.1718 +484 1 0.0481113 7.40468 7.43229 -11.5944 -5.37754 -18.7674 +485 1 1.63473 6.52345 6.62888 -0.301482 5.86022 -13.1885 +486 1 2.54325 7.3746 6.52095 -7.01617 -1.6126 8.94816 +487 1 2.42821 6.65367 7.34715 -0.0947462 -6.49261 12.3075 +488 1 1.66344 7.43005 7.38619 -4.64698 1.83667 -2.7903 +489 1 3.21223 6.51896 6.65614 12.5802 -0.344258 -7.45446 +490 1 4.18524 7.3836 6.50889 -0.948752 5.15796 16.6381 +491 1 4.03479 6.58867 7.43482 10.4531 -7.07785 -21.0648 +492 1 3.31132 7.44815 7.43351 -1.0832 -4.66317 -4.42978 +493 1 5.00814 6.58691 6.66459 -15.2308 20.9466 -24.4589 +494 1 5.70889 7.39626 6.56563 14.4769 6.85637 10.1092 +495 1 5.73775 6.567 7.43094 6.72915 9.63092 8.95959 +496 1 4.91068 7.49261 7.37168 0.330155 -8.28614 -9.94049 +497 1 6.53726 6.65021 6.66417 -1.59265 -6.08794 -3.67401 +498 1 7.37246 7.29875 6.57444 7.56141 13.3939 8.59342 +499 1 7.35261 6.58373 7.49207 23.0737 -16.5957 -35.2353 +500 1 6.60589 7.39349 7.49219 -10.7096 3.92482 -19.5185 diff --git a/examples/mdi/dump.17Jun22.series.driver.mpi.4 b/examples/mdi/dump.17Jun22.series.driver.mpi.4 new file mode 100644 index 0000000000..847432833a --- /dev/null +++ b/examples/mdi/dump.17Jun22.series.driver.mpi.4 @@ -0,0 +1,1527 @@ +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +500 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 8.9390353509656766e+00 +0.0000000000000000e+00 8.9390353509656766e+00 +0.0000000000000000e+00 8.9390353509656766e+00 +ITEM: ATOMS id type x y z f_1[1] f_1[2] f_1[3] +1 1 0.0109462 8.91109 8.87705 -0.258023 0.625273 0.429284 +2 1 0.983178 0.93542 8.91066 -2.88593 0.281032 -1.95154 +3 1 0.886776 0.00353842 0.964105 -0.27179 0.383251 0.443719 +4 1 0.0722273 0.817966 0.815708 -0.663834 1.25489 -0.35451 +5 1 1.82919 8.8603 8.91164 0.346262 0.966337 0.327185 +6 1 2.71374 0.850558 0.0977971 -1.53533 0.952301 -0.539148 +7 1 2.75443 8.9152 0.943835 0.200679 -0.0265554 -0.862232 +8 1 1.72161 0.971413 0.796705 7.79754 -6.0811 1.58835 +9 1 3.47837 0.0294075 0.0515782 2.76325 -2.21894 -0.80311 +10 1 4.43186 0.961325 8.89919 -0.387918 -0.444884 0.950878 +11 1 4.37764 0.00631327 0.801109 0.844344 -0.87322 -0.116598 +12 1 3.59567 0.80748 0.974874 -0.705778 1.85625 -1.80855 +13 1 5.35026 8.89566 0.0208816 -0.442875 -0.272596 -0.473028 +14 1 6.3022 0.978028 0.0782288 -3.05518 -2.94099 -0.889505 +15 1 6.27707 0.0297536 0.962734 -0.0515917 0.772188 -1.05602 +16 1 5.30223 0.918655 0.899444 1.33545 0.759601 -1.29769 +17 1 7.0769 0.0948096 0.0649153 0.098645 -1.06535 0.292165 +18 1 8.09537 0.913626 0.0774105 -0.154847 0.414543 -0.451754 +19 1 8.08165 0.0818588 0.895196 -0.689773 -1.28143 0.929968 +20 1 7.14638 0.885276 0.891299 0.487793 0.733541 0.918445 +21 1 8.89456 1.84483 0.0434425 0.886905 -0.621358 -0.495646 +22 1 0.935681 2.64324 0.0406455 -1.34335 0.213362 -1.25695 +23 1 0.966071 1.69976 0.948945 -7.88058 11.3257 -7.25569 +24 1 0.0121607 2.66637 0.881115 -0.232812 0.533689 1.18415 +25 1 1.85044 1.81859 0.00192994 -1.7495 0.19048 0.1992 +26 1 2.68148 2.7251 0.0685109 -1.25528 -0.916148 -1.01459 +27 1 2.62716 1.70715 0.839166 0.688023 2.33788 1.05919 +28 1 1.6905 2.59418 0.903739 1.58905 0.257971 0.508129 +29 1 3.57454 1.77719 8.88663 0.186742 -0.0628404 0.80372 +30 1 4.38099 2.63699 8.92556 0.253897 0.0578989 -0.178058 +31 1 4.45919 1.78484 0.892793 0.372262 0.580252 -1.28381 +32 1 3.55804 2.657 0.821946 0.208194 0.440929 1.42052 +33 1 5.39579 1.85576 0.0513097 -2.11231 -0.770148 -0.833202 +34 1 6.28486 2.68552 0.0861957 -0.390024 -0.099671 -1.25573 +35 1 6.16167 1.79587 0.852166 3.13123 -0.282736 3.8241 +36 1 5.43841 2.67896 0.926914 -0.906522 -0.132525 -0.585389 +37 1 7.09214 1.72405 8.83985 3.26876 6.20695 4.03515 +38 1 7.96694 2.76043 0.0935037 2.29966 -0.680397 -1.28039 +39 1 8.06525 1.69772 0.940378 0.498274 0.445905 0.0355574 +40 1 7.16698 2.58338 0.88179 -1.8895 -0.0707859 1.12114 +41 1 0.0210451 3.48041 0.0428158 0.862491 -0.329006 -0.681709 +42 1 0.874431 4.40275 0.0131769 0.218928 -0.148848 0.324321 +43 1 0.851364 3.60752 0.914082 0.352487 -0.527665 -0.410754 +44 1 0.0749717 4.51844 0.974577 -0.257295 -0.287753 -0.288054 +45 1 1.76248 3.58626 0.0539576 0.480316 -2.29368 -1.63127 +46 1 2.72367 4.4241 0.0474256 0.0272964 0.241712 -0.452415 +47 1 2.73289 3.61199 0.901343 -0.0645249 -1.94992 -0.502421 +48 1 1.8456 4.38069 0.843492 -0.349918 1.31176 2.27682 +49 1 3.50387 3.55674 0.0315796 1.56114 -0.0224047 0.116984 +50 1 4.49692 4.37908 0.0780585 -4.54206 0.213106 -5.58215 +51 1 4.46671 3.57478 0.880458 -0.334204 -0.938728 0.874478 +52 1 3.58815 4.43 0.950374 0.652985 -1.92511 -1.59862 +53 1 5.3866 3.58372 8.92789 -1.19711 -2.22155 0.617325 +54 1 6.17276 4.37217 8.86047 6.00842 1.34471 4.78274 +55 1 6.27432 3.53871 0.907449 -0.148389 -0.137473 -0.523414 +56 1 5.27909 4.47835 0.809401 8.23917 -3.14067 4.34956 +57 1 7.09737 3.53698 8.87413 0.14026 -0.233191 0.941929 +58 1 7.96586 4.56922 8.84208 6.8748 -6.48505 1.75868 +59 1 8.1189 3.63425 0.96148 -3.00277 -1.46323 -4.15536 +60 1 7.14279 4.43222 0.962078 -0.0459577 0.247999 0.321752 +61 1 8.89637 5.43177 8.92691 0.327116 0.812268 0.0679643 +62 1 0.854018 6.30348 0.0813318 1.06274 -7.24911 -7.87042 +63 1 0.873415 5.41923 0.812761 -0.31071 -0.409433 0.423823 +64 1 8.88236 6.35419 0.863575 -0.753758 -3.06962 -0.690381 +65 1 1.76334 5.40934 8.88249 1.8326 1.29836 1.91996 +66 1 2.68777 6.21767 8.90577 0.0461489 1.51967 -0.262666 +67 1 2.66088 5.41906 0.821357 0.262109 -0.890774 -0.241847 +68 1 1.86017 6.31332 0.804602 -1.38053 -1.13952 0.850174 +69 1 3.64435 5.42051 8.90358 -2.6101 -2.17442 -0.370474 +70 1 4.37466 6.25131 8.85278 3.71832 2.70453 0.946098 +71 1 4.53047 5.2708 0.824393 -3.54051 3.8431 0.931364 +72 1 3.61222 6.27635 0.96909 -4.05414 0.604922 -3.58471 +73 1 5.40042 5.34751 8.8935 -0.719369 -0.36085 0.212296 +74 1 6.18215 6.3156 0.0196993 0.267387 0.110688 0.223648 +75 1 6.27516 5.37868 0.90209 -1.0642 -0.241069 0.481931 +76 1 5.31268 6.25584 0.875522 0.133781 0.115172 0.026661 +77 1 7.20113 5.30633 8.84474 -4.87308 6.78349 0.0391413 +78 1 7.95512 6.30497 0.092705 6.00614 -6.0265 -0.649957 +79 1 8.08767 5.35538 0.811364 -1.15126 0.392579 0.741715 +80 1 7.08607 6.1919 0.926051 0.630581 3.46407 -2.46157 +81 1 8.92405 7.0566 8.88782 -1.53371 0.564813 -0.0213323 +82 1 0.905011 8.13513 0.0600006 -0.504969 -0.194195 -0.00181653 +83 1 0.816253 7.07033 0.801556 1.36958 7.74762 7.34595 +84 1 8.83925 8.07727 0.907684 2.46931 1.67506 1.17354 +85 1 1.86043 7.09328 8.91972 -0.773441 0.857837 1.39948 +86 1 2.76541 7.99166 0.0440794 -0.77809 1.05822 0.425741 +87 1 2.67654 7.18636 0.91183 2.62219 -2.00002 -0.219028 +88 1 1.8788 7.9677 0.915621 -0.894934 2.07357 -1.21117 +89 1 3.59357 7.13026 0.0332195 -0.388167 0.00237965 -0.544686 +90 1 4.38663 8.07233 8.88382 0.174711 -0.440379 0.0897133 +91 1 4.5359 7.22854 0.936578 -2.37627 -1.04519 -2.35662 +92 1 3.63538 7.97981 0.824881 -1.61206 1.29888 2.0997 +93 1 5.3271 7.23059 8.92328 -0.111431 -0.20975 0.289951 +94 1 6.30867 8.05581 8.84577 0.0946421 0.0525728 2.57365 +95 1 6.32003 7.15576 0.891457 -0.2569 -0.483959 0.0547371 +96 1 5.40661 7.9868 0.968462 0.415884 0.0845497 -0.268424 +97 1 7.22798 7.08713 0.0563741 -5.45853 5.72078 -0.51002 +98 1 8.05735 8.06186 0.0753342 -0.611004 1.73052 -2.95918 +99 1 8.10922 7.21906 0.806609 -0.400473 -2.4357 2.42821 +100 1 7.16998 8.08498 0.846622 0.253892 0.388538 0.000271703 +101 1 8.88419 0.00785958 1.88382 0.148531 -0.55276 -3.06718 +102 1 0.806706 0.963107 1.6981 0.146821 -6.1479 7.24676 +103 1 0.81371 8.93107 2.59291 1.58623 0.25767 2.66866 +104 1 0.0914118 0.851308 2.7806 -2.96193 1.34432 -3.85013 +105 1 1.70908 0.055279 1.86232 -0.26684 0.0875329 -0.306957 +106 1 2.72497 0.940903 1.70203 -0.757536 -0.918748 1.71384 +107 1 2.71129 0.0639965 2.67102 -0.311468 0.261861 0.646041 +108 1 1.73889 0.96912 2.64369 0.123913 0.173982 0.666446 +109 1 3.52533 0.0194588 1.83263 1.01391 -0.00454228 -0.284845 +110 1 4.50633 0.992013 1.70842 -3.51938 -2.99082 2.23564 +111 1 4.49463 8.9275 2.60712 -6.23135 -0.421499 6.59704 +112 1 3.51061 0.932206 2.63613 0.265327 0.172351 0.555119 +113 1 5.26459 0.0845656 1.88118 6.41483 1.44516 -5.35427 +114 1 6.26822 0.943133 1.78953 -0.172034 -0.0988047 -0.238973 +115 1 6.20352 0.0931252 2.63772 -0.251863 0.451194 0.97073 +116 1 5.33497 0.961022 2.74861 1.85573 -2.10168 -0.655218 +117 1 7.15143 8.91799 1.69931 0.631991 0.791476 -0.168042 +118 1 8.1075 0.884637 1.85069 -0.145764 0.238097 -0.736312 +119 1 8.10277 0.00424992 2.71008 -1.61591 0.00687295 -1.36275 +120 1 7.06485 0.985537 2.76239 8.19773 -7.92397 -1.18231 +121 1 8.91698 1.83538 1.78872 0.656642 -0.0731624 0.0431027 +122 1 0.901335 2.58954 1.84197 -0.375827 -0.324571 -2.7055 +123 1 0.839546 1.79651 2.68072 1.09251 -0.901613 -0.242728 +124 1 0.0205195 2.75315 2.62687 -0.478759 -0.0106512 -0.67727 +125 1 1.78258 1.70562 1.69835 1.31189 0.545066 2.20675 +126 1 2.77409 2.6552 1.77928 -3.71202 0.456863 -3.25075 +127 1 2.62583 1.79361 2.77487 3.4762 0.328618 -3.48584 +128 1 1.71155 2.69761 2.62919 0.862289 -1.38539 2.38335 +129 1 3.5477 1.79572 1.86096 1.43061 -0.605958 -0.978191 +130 1 4.46749 2.5924 1.76238 -0.0494618 -0.0821277 -0.176353 +131 1 4.52929 1.74324 2.59829 -2.00749 0.662049 0.061349 +132 1 3.48188 2.69682 2.61959 1.88694 -0.141301 3.78311 +133 1 5.34711 1.71486 1.76809 1.96327 2.17405 -0.830705 +134 1 6.24637 2.73306 1.80484 3.10489 -2.12999 -0.788559 +135 1 6.31443 1.71423 2.71392 -8.21546 8.18972 -0.602972 +136 1 5.26572 2.69815 2.75971 0.0267628 0.10355 -0.216257 +137 1 7.18953 1.75159 1.71849 -0.576203 -0.36263 1.38792 +138 1 8.05027 2.77408 1.76451 0.439173 -0.587966 -0.341117 +139 1 8.01591 1.69661 2.74434 0.366947 0.0491547 0.134545 +140 1 7.14772 2.69371 2.58907 0.0738449 -1.92773 2.13155 +141 1 8.86781 3.66165 1.74517 3.90719 -1.47472 3.87657 +142 1 0.936621 4.42773 1.79512 -0.401045 -0.147867 0.321366 +143 1 0.948846 3.59531 2.72105 -0.571635 -0.0105131 -1.06193 +144 1 0.0834486 4.38982 2.63588 -0.524533 1.06652 0.75481 +145 1 1.83432 3.4799 1.75691 0.359017 0.665628 -0.818381 +146 1 2.69175 4.37077 1.75144 0.14004 0.214725 0.925417 +147 1 2.74153 3.6404 2.67912 -0.708299 -3.83642 -3.24565 +148 1 1.87968 4.54846 2.67269 -0.684796 -0.993828 -0.138535 +149 1 3.5441 3.51573 1.77434 0.186245 0.881611 -0.696526 +150 1 4.55171 4.52396 1.79145 -2.75839 -2.91024 -1.57263 +151 1 4.49896 3.65335 2.59498 -1.96388 -1.7196 0.869652 +152 1 3.49741 4.47737 2.77344 8.37692 1.8085 -7.7175 +153 1 5.44145 3.48872 1.74764 -3.05421 3.82286 1.14399 +154 1 6.1743 4.53053 1.74574 0.463366 -1.70291 0.122224 +155 1 6.30198 3.67131 2.70975 -1.07292 -0.185523 -2.51985 +156 1 5.34196 4.38653 2.7007 1.29125 2.52938 -0.102964 +157 1 7.1691 3.54339 1.87445 -0.749456 2.7751 -2.56091 +158 1 7.97266 4.40051 1.79603 0.56071 1.27489 1.72891 +159 1 7.99234 3.49992 2.67525 0.940044 2.40885 0.128516 +160 1 7.18063 4.50303 2.68825 -0.923025 -2.40154 0.0954191 +161 1 8.91159 5.33038 1.82507 -0.0203349 -0.241672 0.333237 +162 1 0.8958 6.32359 1.78851 0.38501 -0.14702 -0.347965 +163 1 0.943571 5.31749 2.71754 -0.318578 -0.34148 0.397124 +164 1 0.0864418 6.28418 2.68726 -1.86154 0.137969 -3.27119 +165 1 1.71465 5.37463 1.6949 -0.232891 -0.268012 0.301526 +166 1 2.72852 6.31988 1.88644 -2.78715 -2.37305 -5.95735 +167 1 2.64735 5.41101 2.73193 1.7471 0.192556 0.973026 +168 1 1.84919 6.27948 2.72157 -0.39498 0.808971 -0.0974847 +169 1 3.48336 5.2657 1.71665 0.625214 2.24561 1.33995 +170 1 4.39296 6.19435 1.72952 3.81534 -0.586193 2.86006 +171 1 4.52517 5.37564 2.62027 -1.99502 -0.45422 2.59567 +172 1 3.56333 6.24537 2.5877 2.83084 0.938216 3.4987 +173 1 5.32581 5.29562 1.86847 5.13697 3.80601 -2.04537 +174 1 6.24758 6.22298 1.79203 0.477004 0.378689 0.56244 +175 1 6.25283 5.44934 2.73731 1.14422 -0.830366 -0.337224 +176 1 5.45416 6.25624 2.6996 -2.42774 -1.74418 -0.22606 +177 1 7.22676 5.41803 1.71412 0.223451 -2.28899 2.0191 +178 1 8.0979 6.3518 1.78861 -0.44204 -0.435572 -0.338725 +179 1 8.01325 5.26918 2.64973 1.18264 0.878361 -0.124926 +180 1 7.11991 6.34415 2.69936 -1.3293 -2.66755 2.78128 +181 1 0.0635545 7.11209 1.72165 -0.371894 2.049 0.790012 +182 1 0.857409 8.07873 1.82753 -0.608672 -0.60495 -0.46291 +183 1 0.930573 7.24697 2.65225 -4.55248 -4.69883 0.513873 +184 1 8.8491 7.95414 2.58819 0.570786 1.09764 -0.00497061 +185 1 1.71811 7.19809 1.77835 0.893245 -0.692356 0.118249 +186 1 2.78024 8.04523 1.70672 -2.88976 2.48107 0.040135 +187 1 2.67012 7.13476 2.61708 -1.16009 2.6938 3.43626 +188 1 1.72659 7.99584 2.64342 2.19305 3.0992 -0.0129086 +189 1 3.48631 7.23394 1.84989 5.35093 -4.92393 -2.00054 +190 1 4.4261 8.04744 1.77118 -0.338387 -0.0128497 0.448007 +191 1 4.41287 7.13619 2.73708 2.81119 1.17101 -3.79683 +192 1 3.52255 7.96143 2.73527 1.04353 0.896155 0.0445218 +193 1 5.31509 7.09458 1.73703 1.75862 -0.357986 2.37379 +194 1 6.31592 8.04277 1.87992 0.07968 -0.344084 0.021952 +195 1 6.19476 7.08883 2.7194 5.13464 2.37882 -2.53303 +196 1 5.31616 7.97076 2.64032 0.139732 0.0575338 -0.0995313 +197 1 7.13779 7.0901 1.87785 -0.856279 1.84142 -1.45962 +198 1 8.00182 8.12007 1.73344 0.812689 0.333431 -0.248462 +199 1 8.01591 7.08327 2.73264 -0.0756439 0.769292 0.331432 +200 1 7.15074 8.00152 2.76416 1.82643 0.942676 -3.56152 +201 1 8.89655 8.9304 3.48678 1.65951 -0.447815 3.8493 +202 1 0.950495 0.819015 3.5162 -1.29532 1.69106 1.16913 +203 1 0.81801 0.0539921 4.51501 3.2278 -0.258036 -5.15445 +204 1 8.85177 0.90744 4.37372 14 -2.90794 10.8129 +205 1 1.78019 0.0426842 3.56938 1.84169 -0.836001 -0.350651 +206 1 2.63146 0.926366 3.57031 0.012479 0.082004 0.331715 +207 1 2.70742 0.0633514 4.41591 -1.37547 -1.33331 0.456319 +208 1 1.7142 0.801654 4.43761 0.662356 1.10176 0.272549 +209 1 3.65397 8.84382 3.54877 -3.56671 5.39916 0.463391 +210 1 4.3911 0.894602 3.52171 0.595814 -0.346452 0.321605 +211 1 4.50401 0.046887 4.49909 -1.14502 -0.949582 -0.274225 +212 1 3.51809 0.843433 4.41351 1.90854 2.37085 -0.229306 +213 1 5.34066 0.0102546 3.52427 -0.108558 0.828678 0.2339 +214 1 6.2908 0.991162 3.59141 -5.23018 -9.53106 -1.9323 +215 1 6.23033 0.0280237 4.46344 1.30838 0.516693 -1.50043 +216 1 5.29132 0.919899 4.38256 0.973507 -2.91573 1.14051 +217 1 7.06389 8.92307 3.63529 1.41369 0.894395 -0.0234904 +218 1 8.13244 0.926287 3.63848 -11.0259 -0.689673 -11.6462 +219 1 8.07431 0.0396355 4.42295 -0.0998371 -0.343464 -0.2111 +220 1 7.15426 0.902415 4.51611 0.37609 -0.87238 -0.174942 +221 1 0.0547819 1.70767 3.52402 -0.0990054 0.634623 1.9504 +222 1 0.990251 2.59589 3.64321 -1.70133 -1.15531 -1.34459 +223 1 0.876254 1.75025 4.46545 0.108846 -0.46015 0.445192 +224 1 8.851 2.6248 4.52232 3.89545 -0.330965 -5.02573 +225 1 1.83233 1.81735 3.53725 -2.40083 -0.602726 2.24699 +226 1 2.73685 2.66072 3.63237 -1.34367 -0.0545412 -0.555358 +227 1 2.76889 1.75912 4.53924 -5.46261 0.887424 -6.31803 +228 1 1.79935 2.60963 4.48075 0.43952 -0.293553 0.768966 +229 1 3.51296 1.81737 3.56522 0.159577 -1.35984 0.863711 +230 1 4.48313 2.73941 3.65804 -0.990489 -8.98093 -5.87222 +231 1 4.37894 1.70897 4.40451 -1.1595 -0.0369555 -0.272198 +232 1 3.5578 2.69572 4.44594 -0.0317478 -0.740538 0.514717 +233 1 5.41644 1.73157 3.63972 -0.214907 2.94643 -2.78853 +234 1 6.22995 2.60145 3.56616 -0.0106554 -0.60109 0.383738 +235 1 6.30303 1.6885 4.42264 -3.32083 3.037 6.44969 +236 1 5.43404 2.73282 4.52181 -0.69148 0.715375 -0.475461 +237 1 7.08666 1.7162 3.65955 7.29974 4.17951 -2.48105 +238 1 8.0318 2.68816 3.49666 -0.181832 0.425298 0.461358 +239 1 8.08432 1.70749 4.5149 -2.31295 1.75558 0.820722 +240 1 7.18431 2.71452 4.51289 0.136997 -0.067144 0.521486 +241 1 8.84691 3.61245 3.64188 4.42683 -0.879675 -3.24184 +242 1 0.916797 4.43325 3.62545 -0.842258 -0.010797 0.0107287 +243 1 0.871748 3.60004 4.51194 -0.301498 0.107107 -0.324598 +244 1 8.92426 4.51452 4.44006 -0.00859866 -1.77564 -0.547037 +245 1 1.68965 3.48331 3.5995 1.50205 1.26015 1.14935 +246 1 2.74619 4.38356 3.49878 -7.16717 1.90489 10.07 +247 1 2.74519 3.65012 4.52097 -2.02388 -3.55766 -1.13857 +248 1 1.75432 4.38414 4.53252 -0.421779 0.409337 0.409015 +249 1 3.58997 3.49254 3.52387 -0.821723 1.10659 0.0739307 +250 1 4.40569 4.52296 3.53187 0.545495 -0.966363 -0.0502063 +251 1 4.38156 3.4874 4.39271 -0.289264 8.2647 7.79533 +252 1 3.54333 4.42257 4.55563 2.80723 11.1106 -9.83606 +253 1 5.27331 3.5295 3.65482 2.61308 2.66186 -0.969787 +254 1 6.16108 4.46828 3.59956 0.599894 -1.41883 -0.240371 +255 1 6.22639 3.63251 4.44985 -0.305031 -0.480252 0.0742084 +256 1 5.31568 4.40222 4.46767 -0.344747 -0.443719 0.00587924 +257 1 7.10015 3.56367 3.49443 2.55034 0.169304 1.35525 +258 1 8.02171 4.37546 3.5697 -1.76106 3.37709 -2.28074 +259 1 8.069 3.64942 4.40708 -2.31714 -3.33053 6.18677 +260 1 7.18438 4.37135 4.52245 -1.79563 0.274401 -0.392524 +261 1 0.0758128 5.3487 3.5652 0.184463 -0.360483 0.192319 +262 1 0.795174 6.30898 3.53894 9.14413 -6.75396 2.48214 +263 1 0.867482 5.30202 4.453 0.791187 0.0370161 0.388706 +264 1 0.00225224 6.31064 4.52093 0.402626 -0.0990512 0.0415993 +265 1 1.75224 5.26394 3.64332 0.696547 0.221295 -0.114908 +266 1 2.74065 6.24856 3.64631 -0.500385 1.40459 -1.64071 +267 1 2.73855 5.4528 4.44688 -5.40773 -5.67129 2.9343 +268 1 1.74472 6.17623 4.53641 0.82995 0.717951 -0.0718944 +269 1 3.48421 5.34442 3.61728 1.66736 -1.06074 -1.09811 +270 1 4.41383 6.35055 3.60638 9.51906 -9.2799 1.43724 +271 1 4.38632 5.26464 4.48258 -0.919101 0.504742 0.900072 +272 1 3.55793 6.1617 4.49469 4.34711 2.82736 -0.340092 +273 1 5.36863 5.28325 3.49178 -0.734818 0.617922 -0.744768 +274 1 6.26503 6.19943 3.66319 0.429882 1.55809 -2.03015 +275 1 6.35487 5.3413 4.44757 0.561767 -0.978785 -0.133344 +276 1 5.27408 6.24166 4.56754 6.98603 1.54355 -5.42942 +277 1 7.19701 5.44828 3.47564 -5.73363 -4.54905 0.0826653 +278 1 7.95668 6.19688 3.55501 6.31824 5.03885 -1.22951 +279 1 8.09251 5.32103 4.3972 -0.525971 0.388914 -0.470954 +280 1 7.21521 6.34275 4.38759 -5.30552 -2.8442 0.851377 +281 1 0.0775826 7.08234 3.53581 -5.46769 7.72822 0.0708503 +282 1 0.933572 7.95134 3.59844 -0.0755868 -0.81045 -0.0294233 +283 1 0.967321 7.07254 4.42487 -1.68738 -0.0136546 1.81969 +284 1 8.87247 7.95576 4.3937 0.743652 0.272325 -0.92866 +285 1 1.76917 7.11669 3.64005 0.930468 -0.723585 -1.50003 +286 1 2.76456 8.10499 3.62233 -0.317456 0.121935 0.766743 +287 1 2.61456 7.10311 4.56718 0.759736 -0.536182 -1.28605 +288 1 1.85332 7.96709 4.49102 -0.903085 0.0612931 0.171005 +289 1 3.6668 7.06536 3.52857 -12.7314 9.15268 1.72289 +290 1 4.37522 8.04334 3.61636 3.8155 -4.43194 -0.0509001 +291 1 4.53661 7.19684 4.42303 -0.089737 0.0836956 0.326132 +292 1 3.62847 8.06443 4.56174 -6.53673 1.14979 -7.53287 +293 1 5.44626 7.09379 3.53396 -2.70855 0.0837127 2.61511 +294 1 6.30058 8.08668 3.48692 -3.50797 -0.210369 1.40313 +295 1 6.24642 7.05504 4.56658 1.23504 0.486666 -1.51311 +296 1 5.40389 8.14153 4.41484 -1.1149 -1.90428 -2.07503 +297 1 7.0793 7.23572 3.56625 0.390898 -5.13728 0.366365 +298 1 8.02564 8.11993 3.55841 -0.989908 -0.0289504 0.0817166 +299 1 7.96341 7.11444 4.5691 3.18586 3.20848 -0.902141 +300 1 7.14662 7.9965 4.39373 -0.0363915 0.663241 1.28885 +301 1 0.0665117 0.0620058 5.29566 -4.76408 0.0634028 3.8487 +302 1 0.920378 0.847838 5.33345 0.704711 1.73157 1.07432 +303 1 0.90733 0.0507073 6.29492 -0.256865 0.383558 -0.568888 +304 1 0.0695806 0.935871 6.21245 0.520609 -0.18085 0.460935 +305 1 1.7158 8.90069 5.2688 0.480844 0.845699 -0.0820744 +306 1 2.72956 0.862321 5.35582 -0.666933 0.680843 -0.243728 +307 1 2.75788 8.89573 6.26927 0.729554 0.867268 -0.717865 +308 1 1.87787 0.918127 6.17945 -0.463015 -0.230718 0.375845 +309 1 3.57292 0.0827463 5.28099 -0.282881 -3.17985 0.660183 +310 1 4.39889 0.831174 5.46088 -0.653335 9.17872 -7.1909 +311 1 4.53367 0.077487 6.1821 0.157227 -8.03625 7.38236 +312 1 3.56635 0.935389 6.31146 0.221361 0.0036999 -1.2625 +313 1 5.44773 8.84526 5.27719 -1.51548 1.46139 3.00719 +314 1 6.272 0.802404 5.33609 -0.667532 1.91594 -0.251293 +315 1 6.22537 8.89219 6.16591 -0.245349 -0.895062 1.43446 +316 1 5.33827 0.94153 6.32303 -1.13614 0.583964 -0.338203 +317 1 7.11863 0.0577427 5.44516 0.0248025 -1.55594 -0.512164 +318 1 7.97781 0.796351 5.39903 0.844611 2.54625 -2.84321 +319 1 8.06017 8.92765 6.18069 -0.104306 -2.31947 1.77241 +320 1 7.18164 0.989783 6.31023 -0.163547 -0.192109 -0.79717 +321 1 0.0916103 1.88258 5.39516 -1.00186 -1.43206 -0.661702 +322 1 0.982314 2.60245 5.42151 0.964023 2.57135 -1.73713 +323 1 0.897632 1.84422 6.25233 0.598171 -0.657266 0.69786 +324 1 0.0925235 2.7239 6.16577 -1.60764 0.211114 1.61705 +325 1 1.82959 1.77578 5.39133 -0.293694 0.755656 -0.589776 +326 1 2.69272 2.74727 5.44011 1.7292 -2.84836 -1.30998 +327 1 2.6889 1.83234 6.17525 0.647659 -0.90616 0.231454 +328 1 1.77521 2.70825 6.28078 0.536701 -0.406727 0.0293567 +329 1 3.51954 1.69427 5.29216 6.69261 0.0739574 6.33581 +330 1 4.4097 2.73314 5.34432 0.344675 0.135757 -0.187596 +331 1 4.40444 1.82369 6.16689 4.836 -4.97823 0.364517 +332 1 3.67178 2.60038 6.25743 -5.49724 5.54416 -0.00203516 +333 1 5.35146 1.77827 5.39473 -0.235283 0.213892 0.835574 +334 1 6.28399 2.77802 5.42862 -0.340126 -0.250486 -0.411738 +335 1 6.23134 1.81375 6.22687 0.0223138 0.244736 0.523936 +336 1 5.32351 2.70513 6.28288 3.08354 -1.69468 -3.77436 +337 1 7.14617 1.80036 5.35567 0.0919136 -0.311209 -0.475968 +338 1 8.0974 2.70612 5.29285 -7.26474 -2.41437 5.10983 +339 1 8.1011 1.88391 6.31294 0.0553936 -2.83177 -2.84321 +340 1 7.18351 2.67214 6.17899 0.615225 -0.197791 1.28477 +341 1 8.87232 3.47935 5.28683 2.9021 4.26792 0.541835 +342 1 0.935261 4.37233 5.44726 0.629241 0.918492 -0.917538 +343 1 0.919878 3.52494 6.23281 0.869805 0.127506 1.01894 +344 1 0.00431382 4.37186 6.33532 0.0302966 1.00444 -0.578346 +345 1 1.87251 3.50381 5.42034 -2.4415 2.77086 0.0779929 +346 1 2.70362 4.48406 5.3041 -1.90814 0.882252 2.42793 +347 1 2.75055 3.50273 6.30756 -1.47013 1.25632 -0.795276 +348 1 1.84448 4.4497 6.22456 -0.665656 -0.501499 -0.145372 +349 1 3.61741 3.6732 5.27884 1.4909 -8.59965 8.97662 +350 1 4.55362 4.53069 5.43699 -1.55164 -1.28771 -1.47171 +351 1 4.52256 3.52483 6.1944 -1.86903 1.10409 1.578 +352 1 3.65361 4.51782 6.21866 -3.39722 -3.70857 0.481797 +353 1 5.32088 3.65892 5.41856 2.55855 -1.45769 -1.45685 +354 1 6.25422 4.4123 5.33119 0.406295 0.346858 0.292537 +355 1 6.15978 3.47786 6.34128 0.227911 3.77427 -2.75081 +356 1 5.33342 4.43001 6.30433 -0.582231 -0.0994195 -0.382533 +357 1 7.19473 3.56016 5.44441 -0.898652 0.294925 -2.64663 +358 1 7.98682 4.41046 5.33513 1.4916 0.0945815 1.20731 +359 1 7.97947 3.58929 6.2697 1.92008 -1.0462 0.640867 +360 1 7.19164 4.45465 6.22659 0.298273 0.832684 -0.26134 +361 1 8.91866 5.33922 5.43231 0.972904 -0.678404 -1.89043 +362 1 0.863832 6.24178 5.44793 2.40494 -1.34388 -3.01765 +363 1 0.840212 5.37684 6.26703 1.52144 -3.32025 -2.26664 +364 1 0.0375152 6.17563 6.19921 -3.52547 2.50803 1.96141 +365 1 1.71406 5.31325 5.33193 0.359992 -0.20317 1.05182 +366 1 2.70446 6.22369 5.28953 -1.67496 -0.128385 2.17513 +367 1 2.62094 5.31478 6.20919 0.620292 0.0770975 0.0647467 +368 1 1.78318 6.16446 6.20286 -0.707464 0.30734 -0.850222 +369 1 3.5001 5.34304 5.42111 1.18155 0.33408 -1.88423 +370 1 4.48409 6.21311 5.27474 -6.47906 -0.498054 6.10955 +371 1 4.40434 5.30746 6.24861 3.30032 4.47126 1.95885 +372 1 3.65651 6.23636 6.35732 0.258101 -0.821502 -0.539452 +373 1 5.37686 5.39062 5.45706 -0.495794 0.303868 0.87367 +374 1 6.27665 6.3275 5.44876 0.578726 -4.19567 -0.915026 +375 1 6.28987 5.34918 6.28481 -0.689441 0.646514 -0.025026 +376 1 5.38856 6.30438 6.29204 -0.62461 -0.174266 -0.144794 +377 1 7.10303 5.36134 5.39788 0.303084 -0.453051 0.575398 +378 1 7.97278 6.2689 5.34555 1.29349 -0.0892034 0.239307 +379 1 8.1123 5.2681 6.25774 -0.648694 -0.661016 0.761589 +380 1 7.23419 6.34793 6.22344 -1.98134 -0.75315 1.10815 +381 1 0.0530217 7.08624 5.43675 -2.76329 0.356415 -1.34254 +382 1 0.891502 8.07734 5.33574 -0.449954 -0.433341 -0.0145848 +383 1 0.859902 7.08778 6.21702 1.22817 0.316603 2.39974 +384 1 8.86723 7.96664 6.28254 0.557062 3.16551 -3.15026 +385 1 1.77928 7.05564 5.34292 -1.2854 -0.797113 0.726349 +386 1 2.74792 8.05162 5.34603 0.580474 -0.247926 -0.00393627 +387 1 2.61984 7.13654 6.2076 0.1179 0.00397349 -0.327299 +388 1 1.73531 7.99204 6.32624 -0.619957 1.84241 -1.57732 +389 1 3.59984 7.17613 5.43634 -0.452415 0.706682 -0.14784 +390 1 4.39821 8.05962 5.28157 7.32724 0.749963 7.12774 +391 1 4.53389 7.20586 6.21186 -1.71384 -1.49003 0.809357 +392 1 3.66572 8.09269 6.23368 0.381787 -1.59697 -1.53597 +393 1 5.43811 7.11751 5.40192 -5.5589 -0.00418968 -4.06356 +394 1 6.35445 7.96959 5.31467 -2.59984 2.44569 0.360222 +395 1 6.17375 7.13942 6.18142 5.31103 3.8936 7.8957 +396 1 5.29125 8.02549 6.29493 1.99742 1.43167 0.441829 +397 1 7.11664 7.15874 5.38774 1.63444 -2.12611 -0.430051 +398 1 8.12983 8.0005 5.26693 -0.350623 0.791023 2.07438 +399 1 8.11089 7.10521 6.29529 -1.02761 -0.414645 -0.639575 +400 1 7.1542 8.04467 6.33119 -0.716395 -2.97685 -2.97233 +401 1 0.0455321 0.0581059 7.13785 -2.59331 -3.08955 0.589456 +402 1 0.853998 0.797568 7.23372 2.25232 12.9399 -9.25923 +403 1 0.893883 0.0531987 7.95582 -0.265032 -9.78891 10.4341 +404 1 0.0979374 0.927475 8.08374 -1.27945 -0.625441 0.909779 +405 1 1.70883 0.0184568 7.15475 0.947479 -0.211015 -0.0644084 +406 1 2.65212 0.910749 7.07723 -0.301347 -0.213339 -0.337826 +407 1 2.6305 8.90469 8.0727 2.55272 1.71066 0.384582 +408 1 1.75018 0.91387 8.02574 -0.526684 -0.686186 -0.483147 +409 1 3.61403 8.84934 7.06612 1.02988 1.44024 1.76178 +410 1 4.42034 0.91943 7.17223 0.522178 -1.61468 -2.10925 +411 1 4.37056 0.0516865 8.14003 0.0263315 0.189467 -0.466418 +412 1 3.59 0.934896 8.00045 0.0371044 1.00787 1.05016 +413 1 5.2816 0.0108877 7.14004 0.0410715 -0.366939 -0.311788 +414 1 6.23624 0.898837 7.05965 1.021 0.941131 0.654753 +415 1 6.246 8.87468 8.06175 -0.280098 0.535663 -1.1759 +416 1 5.31648 0.815501 8.12607 -0.78801 0.243527 -0.599256 +417 1 7.10707 8.84874 7.08197 -0.468775 2.08644 1.86713 +418 1 8.05013 0.946529 7.22788 -1.5208 -0.582053 0.186559 +419 1 8.1301 8.84043 8.01457 0.052244 0.715074 -0.282442 +420 1 7.06838 0.987221 8.03414 10.0415 -13.6791 -1.19755 +421 1 8.86835 1.70934 7.22731 2.54892 2.22649 -0.22541 +422 1 0.866325 2.76414 7.15029 -0.0137847 -2.49225 -3.8584 +423 1 0.826708 1.83336 8.03111 1.70357 -1.53255 0.309164 +424 1 0.0511912 2.65175 8.02861 -1.53037 1.53618 -0.152554 +425 1 1.7237 1.71044 7.1133 -0.3904 -0.435435 -0.731182 +426 1 2.66636 2.72018 7.14295 0.547793 -0.274295 0.648117 +427 1 2.70105 1.80209 8.13576 -0.0852062 -0.133841 -0.000493208 +428 1 1.77492 2.76081 8.10399 0.564357 -0.308093 0.985398 +429 1 3.66205 1.87543 7.16799 0.15905 -2.5091 -2.55207 +430 1 4.55348 2.70177 7.05301 -5.50098 -2.53366 3.01389 +431 1 4.46818 1.71608 7.96441 0.32513 1.80226 3.00161 +432 1 3.56091 2.58808 8.02945 0.396266 1.95642 2.12785 +433 1 5.36149 1.84637 7.16969 0.516803 -0.0610583 -0.802699 +434 1 6.28291 2.77184 7.1854 -0.512674 -3.17359 2.22694 +435 1 6.3427 1.71551 7.9726 -15.2061 11.4078 1.6664 +436 1 5.45463 2.61593 8.09933 0.73198 1.12429 -0.810915 +437 1 7.14617 1.80598 7.24022 4.03182 0.503759 -4.81039 +438 1 8.07521 2.6756 7.07092 -0.336894 3.22322 3.478 +439 1 8.11875 1.8373 8.10797 -1.57974 -0.493075 -0.537868 +440 1 7.09714 2.63714 8.02739 -0.0173147 0.820696 1.90431 +441 1 8.85027 3.56499 7.15253 3.00565 -1.27064 -0.682205 +442 1 0.885235 4.38222 7.18774 -1.842 1.22146 -0.226395 +443 1 0.884771 3.48141 7.97536 -0.530218 4.3971 3.23625 +444 1 0.0419078 4.41462 8.04436 -0.806344 -0.262731 -0.956831 +445 1 1.73746 3.66699 7.09267 1.85773 -3.96877 -1.41987 +446 1 2.66489 4.55163 7.19564 0.399017 -1.47837 -0.325749 +447 1 2.68401 3.61278 8.06372 0.262338 -0.0680464 0.329915 +448 1 1.80878 4.38262 7.9551 -1.46544 1.49945 2.09645 +449 1 3.55441 3.63471 7.17184 -0.0924634 0.45212 0.606799 +450 1 4.40759 4.53436 7.23701 0.160045 0.252781 -1.03281 +451 1 4.47938 3.49218 8.04219 0.177099 0.0940276 0.00712601 +452 1 3.55379 4.48752 8.06012 -0.927856 0.341505 -0.0833457 +453 1 5.30335 3.52949 7.1279 2.00125 1.71282 0.0663191 +454 1 6.19233 4.44015 7.09395 -0.123778 -0.82645 0.684973 +455 1 6.31698 3.55227 8.05766 -1.80584 -0.932697 -1.1518 +456 1 5.41804 4.43351 8.09204 -4.30063 -0.218755 -3.96516 +457 1 7.232 3.50321 7.24512 -0.569054 0.129485 -1.05452 +458 1 8.04777 4.39134 7.10023 -0.415559 1.27013 1.1937 +459 1 8.09921 3.54644 7.99275 -0.904288 0.185761 1.62031 +460 1 7.15284 4.38151 8.0646 -0.281528 0.0795406 -1.17401 +461 1 8.85944 5.36104 7.19522 1.71386 -0.372777 -2.67299 +462 1 0.808445 6.15874 7.05432 0.343929 1.70028 2.25424 +463 1 0.99266 5.36055 8.05319 -1.96195 -0.361049 -1.35199 +464 1 8.9228 6.22111 8.03716 -0.328906 0.253391 -0.16959 +465 1 1.7511 5.27554 7.16317 -0.501838 -0.493478 -1.59379 +466 1 2.7323 6.31099 7.08452 0.463177 0.0720173 0.389338 +467 1 2.75106 5.38162 8.09911 0.530948 -0.923774 -0.761524 +468 1 1.80446 6.33727 8.00982 0.567564 -0.353842 0.999402 +469 1 3.53218 5.32026 7.15711 1.3552 1.44822 0.141569 +470 1 4.49512 6.19462 7.20137 -2.95094 2.57244 -4.09211 +471 1 4.4829 5.43783 8.04952 -1.75843 -3.70774 -0.194014 +472 1 3.65767 6.24252 7.97233 -2.18137 -0.334806 -0.189717 +473 1 5.35752 5.46295 7.14871 1.05371 -2.23541 -1.50951 +474 1 6.22804 6.29485 7.12141 -0.370188 0.264704 -0.149428 +475 1 6.34127 5.4593 8.01496 -0.759119 0.239406 -0.0100712 +476 1 5.27101 6.21963 7.98358 4.21356 3.70888 3.53999 +477 1 7.2413 5.39744 7.15422 0.63332 0.408861 0.0765336 +478 1 8.01209 6.33115 7.20214 1.04149 -1.50251 -0.643312 +479 1 8.11155 5.33363 8.02803 -2.08279 1.51127 0.153008 +480 1 7.20203 6.31049 8.06426 -0.105023 -0.935886 0.140492 +481 1 8.92362 7.24394 7.10015 0.0792153 -3.18157 4.09933 +482 1 0.865164 8.02092 7.22606 2.85769 1.65383 -2.61434 +483 1 0.86745 7.15339 8.01815 -0.578541 -0.380635 0.364655 +484 1 0.0284189 8.08161 7.95725 -0.890268 -0.349283 1.10066 +485 1 1.85656 7.22057 7.11535 0.397315 -1.70504 3.16253 +486 1 2.77375 7.96501 7.15423 0.0953595 0.0574297 -0.272157 +487 1 2.64437 7.22314 8.11966 1.48696 -0.179689 -2.12782 +488 1 1.85941 8.11413 7.96635 -2.35368 -2.50728 -0.754549 +489 1 3.67468 7.10829 7.12824 0.65987 0.70298 0.656082 +490 1 4.46621 7.99739 7.2078 2.25404 -0.456947 -2.59682 +491 1 4.48001 7.09955 8.01357 0.0334801 0.324585 -0.290932 +492 1 3.6378 8.02597 7.95299 -1.96867 -0.619231 2.20677 +493 1 5.31589 7.17259 7.15585 0.23145 -0.930936 -0.437425 +494 1 6.20936 8.03122 7.09513 -0.13604 -0.296447 0.152582 +495 1 6.17543 7.22187 8.09898 5.44884 -7.61495 -1.62058 +496 1 5.43883 7.98222 8.0181 -6.37262 6.00913 -1.00537 +497 1 7.14576 7.09705 7.14015 0.407174 1.49093 0.0363952 +498 1 8.02588 8.07609 7.1284 1.43118 -1.40285 -0.689018 +499 1 7.99317 7.15919 8.00286 1.19218 0.601266 0.682892 +500 1 7.2435 8.04597 7.97482 -1.89044 -0.246287 0.1524 +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +500 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 8.5498797333834844e+00 +0.0000000000000000e+00 8.5498797333834844e+00 +0.0000000000000000e+00 8.5498797333834844e+00 +ITEM: ATOMS id type x y z f_1[1] f_1[2] f_1[3] +1 1 0.0109462 8.52194 8.48789 1.60777 3.16074 4.93288 +2 1 0.770239 0.886587 0.0775241 5.1148 0.619933 -4.35337 +3 1 0.914855 8.54009 0.795212 -2.54709 2.40671 3.27622 +4 1 8.53949 0.79582 0.824294 -1.87361 -0.316163 2.22706 +5 1 1.68126 8.45058 8.49491 -0.796772 17.9401 13.8601 +6 1 2.49257 0.906431 0.000759221 8.8197 -0.476032 2.96817 +7 1 2.62932 0.0354753 0.888378 -4.43263 -0.45206 -5.76212 +8 1 1.71329 0.913566 0.778252 -3.74188 -4.37189 3.26227 +9 1 3.42175 0.0965993 8.49503 -4.75784 -8.08943 10.1901 +10 1 4.21271 0.889278 8.46971 8.07159 3.26979 7.09905 +11 1 4.30903 0.0721078 0.771319 -2.20196 2.16322 3.01896 +12 1 3.42332 0.912751 0.876126 -1.2014 -0.27869 -2.68959 +13 1 5.04057 8.48132 8.46735 12.114 4.06773 4.60111 +14 1 5.95626 0.830289 0.0884189 2.64036 5.56585 -7.9642 +15 1 5.95178 0.0392781 0.802073 0.496214 -5.11156 5.55524 +16 1 5.1151 0.919125 0.80056 -4.53937 -3.75487 2.57161 +17 1 6.8031 8.46299 8.54479 -1.12262 1.88258 -1.67969 +18 1 7.77702 0.837169 8.46101 -2.81144 0.601723 4.97774 +19 1 7.61766 0.0190488 0.807902 2.02145 -3.01975 -0.996798 +20 1 6.83813 0.841817 0.893784 2.20091 1.15146 -3.46095 +21 1 0.00483518 1.7748 8.45086 3.14001 0.0124508 7.14446 +22 1 0.925315 2.54775 8.47859 -2.14676 3.17757 1.68537 +23 1 0.946475 1.73152 0.932031 -7.90083 -3.0997 -5.49951 +24 1 0.0820864 2.59152 0.95052 -16.5003 -1.1863 -19.4267 +25 1 1.62363 1.68342 8.4651 1.8496 1.86303 2.33818 +26 1 2.56251 2.66233 0.0202936 -6.7309 -4.60627 -0.0436147 +27 1 2.47347 1.71611 0.900003 2.27232 1.93928 0.205074 +28 1 1.66562 2.5538 0.89239 8.29789 -0.0162708 -2.14995 +29 1 3.47808 1.70927 8.49067 -6.21947 -0.00998514 1.91211 +30 1 4.19294 2.51037 0.0787296 16.1199 8.28753 -17.6776 +31 1 4.29711 1.73051 0.787489 0.142042 -5.75402 7.11231 +32 1 3.43681 2.6439 0.75999 -11.309 -9.11906 21.9869 +33 1 5.20599 1.76704 0.0398807 -10.2389 -11.7619 -5.76949 +34 1 5.91436 2.52733 8.51501 10.4145 9.83206 -1.49498 +35 1 5.9033 1.67223 0.919622 10.1161 4.25667 -5.1777 +36 1 5.15205 2.55373 0.788133 -1.76953 2.31199 6.90362 +37 1 6.92232 1.70971 0.0701593 -2.50899 -1.62202 -0.822044 +38 1 7.5955 2.61765 0.0592135 2.55821 0.640647 0.0382532 +39 1 7.74881 1.7729 0.896218 -1.59166 -5.96851 -6.46077 +40 1 6.80231 2.56106 0.910949 5.84287 -4.44794 -4.99646 +41 1 0.028349 3.48236 8.49963 2.5025 -5.04288 3.39467 +42 1 0.836484 4.27887 0.0816773 0.760548 2.93196 -2.43461 +43 1 0.942186 3.3633 0.783926 -3.69777 5.09684 -0.0674025 +44 1 8.51583 4.33027 0.838505 2.60137 -0.826864 1.21094 +45 1 1.65067 3.4812 8.47243 0.730068 -2.57113 1.91442 +46 1 2.5668 4.2649 8.54781 -0.773361 3.29166 6.51609 +47 1 2.51515 3.35935 0.92744 0.397687 12.5391 -13.0985 +48 1 1.73465 4.30243 0.83421 -1.47193 -2.67124 0.923933 +49 1 3.37869 3.37397 0.0291446 3.12688 15.3224 -6.53558 +50 1 4.34738 4.34434 0.00829503 -5.52046 -6.93359 -2.07611 +51 1 4.32411 3.36572 0.836745 -2.16657 1.87946 3.00206 +52 1 3.33524 4.20214 0.9322 3.17725 3.34929 -6.83564 +53 1 5.08499 3.41929 0.036632 4.03928 -2.58738 -4.81317 +54 1 6.04127 4.33974 8.49644 -0.624803 -0.102814 0.982479 +55 1 6.01611 3.33685 0.909561 -5.08671 5.06768 -6.62403 +56 1 5.207 4.2377 0.760733 -1.32975 0.891019 3.81461 +57 1 6.81304 3.47817 0.0178755 -0.843928 -8.06693 -2.50137 +58 1 7.73203 4.2048 0.00740382 -1.99245 1.66716 -1.57857 +59 1 7.78831 3.44874 0.953497 -3.78613 -1.03229 -4.77194 +60 1 6.90781 4.17709 0.825008 -1.46363 4.64194 5.22986 +61 1 8.46845 5.09622 8.47404 12.6898 1.90364 12.9104 +62 1 0.797366 5.93181 8.52222 2.38416 2.33873 2.4531 +63 1 0.806155 5.19524 0.885366 4.86564 -4.44474 -2.27198 +64 1 0.0123025 5.95271 0.830227 -4.90982 1.72838 0.59014 +65 1 1.70825 5.09756 8.50872 2.27411 3.17124 11.7261 +66 1 2.57892 5.99612 8.47434 -1.64581 0.780097 1.78814 +67 1 2.53606 5.08073 0.912891 1.82428 2.12405 0.338003 +68 1 1.76245 6.06361 0.855052 -0.817516 -1.26047 -0.587481 +69 1 3.36815 5.1611 0.0892763 -1.75416 -1.94918 -4.15038 +70 1 4.34388 5.99478 8.53994 -9.12199 -5.82315 -0.643131 +71 1 4.22842 5.14974 0.779802 4.93843 -0.926739 3.98855 +72 1 3.45177 5.94376 0.905424 -5.40353 3.18508 -3.48186 +73 1 5.06545 5.13306 8.4631 8.02458 6.68819 3.23791 +74 1 5.91929 6.01015 8.53548 3.77131 -1.20656 -2.03594 +75 1 5.88805 5.11842 0.816496 5.73582 1.96394 -4.01157 +76 1 5.18785 6.02276 0.820364 -9.36617 -3.77225 -2.84856 +77 1 6.8933 5.1517 8.49766 -1.10898 -0.445881 0.788116 +78 1 7.73242 5.99103 8.48869 1.48322 -7.68495 9.10162 +79 1 7.66553 5.0457 0.7869 0.413505 3.32493 1.60624 +80 1 6.9298 5.9353 0.896867 -3.44217 0.759559 -1.89572 +81 1 0.0757853 6.76414 0.08264 -2.09776 5.63137 -2.35842 +82 1 0.929754 7.68563 0.0937614 -14.24 2.10473 -10.1605 +83 1 0.947372 6.93568 0.898093 -37.7638 -41.2899 -5.14895 +84 1 0.0463649 7.75037 0.902481 -0.259219 -2.38896 -3.08434 +85 1 1.64115 6.89463 8.52754 6.28385 -7.53573 1.49633 +86 1 2.53763 7.75472 8.45351 15.1175 -6.89071 16.4408 +87 1 2.60347 6.88355 0.853331 -4.53589 -3.86491 -4.69681 +88 1 1.61173 7.63221 0.905993 43.7793 33.7511 -1.13346 +89 1 3.3813 6.82692 8.54355 -0.238432 1.95456 2.34043 +90 1 4.24371 7.77989 0.043504 -5.67067 -7.72392 -1.84442 +91 1 4.1828 6.86814 0.818276 1.21815 -0.827933 0.630987 +92 1 3.3368 7.7382 0.923275 7.52639 -2.01137 -4.72269 +93 1 5.071 6.7563 0.010658 5.49209 11.6713 -3.15323 +94 1 5.90188 7.6356 0.0424163 1.86621 0.862931 -1.97936 +95 1 6.03172 6.8673 0.938495 -1.34369 1.09475 -9.39496 +96 1 5.15248 7.77523 0.857214 -2.90101 -1.73408 2.05686 +97 1 6.89959 6.76423 0.01648 -11.1028 0.34724 0.750719 +98 1 7.65506 7.70409 0.0429309 2.74021 -1.34663 -2.67212 +99 1 7.64597 6.8087 0.792436 6.14337 0.285334 5.54838 +100 1 6.81299 7.61529 0.784654 1.50923 3.73377 2.87701 +101 1 0.039157 8.46192 1.76149 -3.85041 1.88762 -2.12951 +102 1 0.799188 0.819633 1.69376 4.21763 0.723161 -3.63495 +103 1 0.763005 0.0408753 2.55669 11.5628 -1.30287 -1.53659 +104 1 0.0652633 0.934891 2.49039 -5.1145 -1.67274 5.33691 +105 1 1.66381 8.45402 1.66249 1.87623 5.22247 1.17986 +106 1 2.503 0.802578 1.65731 0.0918423 3.77669 3.70231 +107 1 2.51579 0.0135642 2.53917 0.463256 0.0266605 -0.815012 +108 1 1.65685 0.926197 2.57259 5.9178 -9.1905 -0.306187 +109 1 3.4242 0.0443963 1.67808 1.33331 -0.794171 2.32841 +110 1 4.23298 0.877511 1.6619 2.15651 0.36791 0.599305 +111 1 4.23114 8.48221 2.59613 0.139704 5.19667 3.26797 +112 1 3.42382 0.825355 2.52764 0.831325 -0.597344 0.750298 +113 1 5.10755 0.098598 1.64667 1.13835 -0.15217 0.418453 +114 1 6.07979 0.861483 1.66377 -9.38879 -3.1028 5.61252 +115 1 6.06362 0.0403691 2.64895 -6.98521 -8.98289 -11.9164 +116 1 5.20913 0.939312 2.59362 -1.28414 -1.16831 -2.67638 +117 1 6.75529 8.52816 1.79359 4.36806 -0.709446 -4.01445 +118 1 7.76101 0.764033 1.62558 -1.73868 3.93794 4.49945 +119 1 7.66206 0.0708021 2.53607 1.47505 -2.32899 1.29594 +120 1 6.92286 0.947435 2.52138 -4.88314 -16.5943 7.22153 +121 1 8.51449 1.72985 1.71942 6.76951 -3.05423 -0.995536 +122 1 0.834691 2.62553 1.61171 16.0236 -0.437826 23.4167 +123 1 0.945534 1.71145 2.53519 -17.6422 5.766 10.6769 +124 1 8.53575 2.60321 2.48391 2.61084 -9.58061 10.2444 +125 1 1.63294 1.72028 1.76938 14.1815 -0.440268 -11.5313 +126 1 2.57682 2.65502 1.67415 2.8611 -15.9615 10.724 +127 1 2.65189 1.65955 2.48962 -4.47742 1.085 2.58429 +128 1 1.79145 2.49644 2.55538 0.0425348 2.96537 1.56716 +129 1 3.45687 1.73281 1.73911 -3.75938 -0.279924 -8.91417 +130 1 4.34908 2.51749 1.7514 -3.12574 5.69408 -7.34516 +131 1 4.21985 1.73239 2.48294 4.56177 -5.44217 8.83153 +132 1 3.39941 2.5984 2.48766 0.0932155 -0.49927 3.02478 +133 1 5.22539 1.80308 1.7328 -5.21779 -2.43895 2.23844 +134 1 6.07426 2.60134 1.71356 -9.82102 -9.11759 6.53349 +135 1 6.06098 1.72463 2.48049 -24.0059 1.32147 25.9525 +136 1 5.04217 2.48583 2.60699 6.13261 3.37855 2.31458 +137 1 6.77443 1.68358 1.80416 26.2694 11.8834 -33.3324 +138 1 7.78345 2.52468 1.65191 -10.0717 7.23238 6.81167 +139 1 7.67217 1.70427 2.51662 7.38759 5.50979 0.483479 +140 1 6.87655 2.54802 2.65887 0.828003 6.30102 -11.6733 +141 1 8.48905 3.38009 1.79052 3.95862 11.358 -4.16794 +142 1 0.904648 4.31805 1.73458 -1.64595 0.0791848 -3.59387 +143 1 0.882159 3.48871 2.5578 -1.47386 -2.40831 0.515883 +144 1 0.0640856 4.36164 2.51005 -1.54232 -2.6948 -1.06039 +145 1 1.78366 3.38548 1.78248 -8.79706 -1.19951 -6.15917 +146 1 2.61647 4.18826 1.75601 -13.6767 13.2656 0.0962066 +147 1 2.49967 3.46972 2.59724 11.287 -7.88562 -0.187146 +148 1 1.72994 4.21494 2.4741 -1.76295 10.5241 6.69302 +149 1 3.35408 3.46945 1.74549 12.0923 -11.3982 2.63093 +150 1 4.33371 4.2573 1.65266 -1.0572 -0.0681575 -0.357999 +151 1 4.25135 3.37501 2.62082 -0.724851 2.23609 -3.08367 +152 1 3.37046 4.34755 2.6064 0.218455 -8.01846 -3.14612 +153 1 5.16664 3.3978 1.80383 -2.26051 -2.46633 -4.30603 +154 1 6.02075 4.21565 1.63908 -0.444656 2.88859 -0.464916 +155 1 6.04443 3.46025 2.46975 -2.50911 -3.21487 7.82311 +156 1 5.06457 4.21348 2.57808 1.01082 5.99339 -2.31274 +157 1 6.80721 3.3694 1.6818 12.0846 7.00158 1.77966 +158 1 7.66426 4.31037 1.75089 1.93845 -1.12426 -1.15071 +159 1 7.67666 3.35746 2.66226 0.0349977 1.35377 -1.51011 +160 1 6.86746 4.18845 2.58559 1.34212 2.76274 1.29577 +161 1 0.0121787 5.21746 1.67805 -1.66136 -3.05338 2.49187 +162 1 0.848043 6.06063 1.634 -1.152 -1.54074 2.03353 +163 1 0.891535 5.1714 2.53903 -1.80088 0.0367987 2.5043 +164 1 8.53141 6.02479 2.48115 1.46529 0.600203 2.28151 +165 1 1.67096 5.18637 1.75513 2.90335 -0.353263 -4.03581 +166 1 2.63344 6.0279 1.70432 -16.3644 -8.57778 -6.55322 +167 1 2.48532 5.10477 2.59913 0.462017 -0.718364 -1.79537 +168 1 1.74617 5.95248 2.59859 0.0442724 3.34654 -0.327538 +169 1 3.3871 5.11741 1.76498 -0.70902 0.100622 -1.55997 +170 1 4.23897 5.91622 1.65627 3.82091 1.24022 3.5679 +171 1 4.18272 5.19526 2.64844 4.07887 -0.154168 -2.99301 +172 1 3.33243 6.04257 2.48749 13.2178 -9.29314 8.76503 +173 1 5.21355 5.13048 1.6694 -5.38913 -0.724028 1.81762 +174 1 5.88731 6.04999 1.61164 27.08 -23.484 7.87668 +175 1 5.91685 5.19555 2.55373 8.22272 -5.32197 -1.91553 +176 1 5.22513 6.01752 2.48789 -6.37641 3.03262 4.81469 +177 1 6.87923 5.14396 1.75241 -1.31228 -0.52571 -0.175031 +178 1 7.66325 6.00346 1.75398 1.55065 0.721262 -1.56625 +179 1 7.71088 5.21107 2.64045 -0.197441 -3.63935 -3.47269 +180 1 6.81367 6.03163 2.50271 -0.887486 -5.65654 8.47366 +181 1 8.45469 6.86312 1.68381 5.32955 -1.93357 -1.0964 +182 1 0.887234 7.64699 1.70441 -8.03342 4.67955 6.65869 +183 1 0.827773 6.84361 2.49826 0.666014 -0.927683 2.41577 +184 1 0.0243326 7.6531 2.64337 -2.41729 -1.59288 -7.26092 +185 1 1.67566 6.82407 1.70759 6.3287 0.149047 4.42322 +186 1 2.51454 7.65687 1.63227 -3.24159 2.2536 7.24906 +187 1 2.61047 6.80534 2.59521 -8.48569 7.62473 -2.75927 +188 1 1.62469 7.75189 2.55083 1.70283 -3.32336 -0.400725 +189 1 3.32845 6.81114 1.68061 10.3844 9.25335 0.5217 +190 1 4.35781 7.7751 1.79868 -7.49989 -3.23754 -13.7369 +191 1 4.19243 6.92819 2.60428 15.2501 -13.591 -1.36339 +192 1 3.43706 7.60555 2.52571 -13.7857 14.6138 -0.968483 +193 1 5.20185 6.77695 1.66316 -21.9331 19.6829 3.32007 +194 1 5.90138 7.62608 1.77842 3.59956 5.50204 -2.20333 +195 1 5.95566 6.93899 2.64467 1.5684 -14.0837 -9.48217 +196 1 5.06902 7.62841 2.55428 6.74225 1.46675 8.63059 +197 1 6.76742 6.8085 1.78801 1.36869 6.36826 -6.59728 +198 1 7.65843 7.62584 1.68675 -2.22178 4.8322 -2.62428 +199 1 7.67415 6.89867 2.52463 2.21143 -5.15334 3.5596 +200 1 6.87662 7.66202 2.55284 -3.26152 2.73313 1.32325 +201 1 0.0405641 8.51038 3.32948 -5.92557 3.54592 8.59039 +202 1 0.809165 0.908392 3.38948 1.71953 -1.70344 0.923667 +203 1 0.901714 8.46653 4.19384 -9.71216 4.93867 8.34322 +204 1 0.069999 0.928448 4.31429 -4.27362 -2.53344 -6.14786 +205 1 1.6264 8.4509 3.42354 8.98155 6.03203 -6.76996 +206 1 2.65602 0.762944 3.43842 -5.54094 5.64927 -11.0802 +207 1 2.61793 0.0468587 4.22961 -1.55064 -6.54911 6.6458 +208 1 1.68094 0.888048 4.32275 0.711784 -4.72688 -3.71581 +209 1 3.43429 8.45723 3.40115 7.64008 12.4108 0.619842 +210 1 4.23416 0.880739 3.42582 5.39503 -6.32873 -0.402512 +211 1 4.18642 8.4609 4.33191 11.6244 16.7018 2.29066 +212 1 3.36155 0.898574 4.22656 4.93072 -1.64922 5.55995 +213 1 5.13206 0.0787666 3.45034 -0.945527 -3.11163 -2.8253 +214 1 6.05542 0.815095 3.33818 0.680768 11.3265 10.7561 +215 1 5.88615 0.068379 4.32153 11.9175 -9.57172 -8.45948 +216 1 5.21525 0.885851 4.19789 -5.15816 5.54694 4.34946 +217 1 6.80589 8.45257 3.40423 5.88256 0.0541198 6.21084 +218 1 7.74454 0.870555 3.46229 0.501904 -4.05279 -5.44709 +219 1 7.62711 0.0144156 4.35804 1.95636 -0.757148 -6.431 +220 1 6.7475 0.756319 4.34542 2.82117 3.60456 -0.442947 +221 1 0.046471 1.74765 3.48426 -2.94726 0.460616 -2.28233 +222 1 0.888532 2.54472 3.37968 0.966992 1.17998 0.546373 +223 1 0.832134 1.79852 4.28422 5.1168 -14.8036 -11.8055 +224 1 0.0855384 2.60849 4.37243 -9.37894 3.13224 -11.0091 +225 1 1.76053 1.64213 3.45381 -3.40447 2.71972 -2.85028 +226 1 2.52635 2.61582 3.43297 3.65437 -1.51294 -3.08517 +227 1 2.50122 1.75788 4.25552 8.72555 -0.689386 -1.86072 +228 1 1.75205 2.6278 4.21833 -8.89154 -5.54607 2.69229 +229 1 3.50205 1.65486 3.36684 -7.50491 6.39615 -0.836562 +230 1 4.28152 2.60594 3.4252 -1.76945 -2.76432 2.53661 +231 1 4.17705 1.67239 4.28707 6.76533 -1.25356 -1.29705 +232 1 3.44438 2.47178 4.25656 -4.81944 5.002 -0.576402 +233 1 5.22486 1.68937 3.43619 -3.28026 2.78772 -4.39101 +234 1 6.02069 2.55292 3.33778 -3.72236 0.507942 3.01424 +235 1 5.96152 1.77008 4.23889 4.98563 -0.248026 3.40967 +236 1 5.17107 2.61009 4.24734 -0.598251 0.473097 -0.376582 +237 1 6.87337 1.72985 3.32607 -2.78397 -6.76638 7.83701 +238 1 7.692 2.50127 3.44714 2.52098 2.71173 -0.194497 +239 1 7.63531 1.64894 4.19535 0.881487 3.19892 6.53537 +240 1 6.92924 2.5559 4.32195 -3.68781 1.74243 -2.92343 +241 1 0.0154582 3.42553 3.38818 0.573657 0.250438 1.11994 +242 1 0.946668 4.34133 3.49534 -14.1263 -16.7645 -9.90419 +243 1 0.911751 3.43019 4.31621 -0.850264 0.755291 -1.68921 +244 1 0.0046042 4.25775 4.34424 -1.31738 -1.24756 -1.54253 +245 1 1.76086 3.48229 3.3966 -12.418 -8.98763 3.21891 +246 1 2.48605 4.22978 3.40508 14.0841 10.3397 -4.15997 +247 1 2.54799 3.33831 4.30225 4.92033 13.8543 -7.00111 +248 1 1.7676 4.3622 4.17566 0.280546 -16.6448 26.3844 +249 1 3.37038 3.45998 3.42173 -0.200746 -1.45028 -1.29578 +250 1 4.20874 4.30541 3.50172 4.65367 -11.48 -19.1828 +251 1 4.21154 3.43635 4.23457 4.19917 -3.40534 2.03948 +252 1 3.45806 4.23712 4.25878 -8.55751 2.75292 6.08306 +253 1 5.11168 3.47839 3.3691 -0.311412 -5.69502 5.70804 +254 1 5.92148 4.26406 3.41002 5.13821 -1.04796 0.0327238 +255 1 6.02264 3.46008 4.23226 -3.02748 -3.55814 1.41554 +256 1 5.17114 4.24863 4.35423 -2.77791 4.93248 -13.0008 +257 1 6.86557 3.34851 3.50434 -4.54964 -0.0741147 -9.06001 +258 1 7.67607 4.29403 3.50495 4.02814 6.65377 -10.7943 +259 1 7.67432 3.49417 4.17544 8.6417 -11.3672 14.2425 +260 1 6.8466 4.22166 4.23144 -3.46256 4.46394 4.938 +261 1 0.0814499 5.05812 3.37338 -2.94602 3.43381 2.0972 +262 1 0.952662 5.9924 3.43554 -2.60446 0.4469 0.54362 +263 1 0.765082 5.07607 4.26673 5.31334 4.0071 5.5605 +264 1 0.0672914 5.95184 4.29838 -1.77164 3.23629 -2.96482 +265 1 1.64676 5.09677 3.49021 9.45599 25.7387 -15.7709 +266 1 2.59524 6.06011 3.441 -1.69946 -11.0916 -4.14222 +267 1 2.46878 5.21999 4.3176 5.41184 -22.6386 -22.4739 +268 1 1.72435 5.99765 4.33067 -8.961 3.18884 -2.81076 +269 1 3.33576 5.13502 3.32819 -1.95672 4.97188 10.3591 +270 1 4.33219 6.01601 3.4905 -3.43576 -1.4684 -1.43775 +271 1 4.2868 5.05318 4.19611 2.54498 12.874 12.0539 +272 1 3.47487 5.92769 4.31716 -1.095 0.823289 -0.856965 +273 1 5.22135 5.10776 3.40172 -8.93936 2.06172 1.30023 +274 1 6.0405 5.92456 3.43523 0.724841 2.24513 0.144002 +275 1 5.92006 5.1314 4.26005 8.25611 -3.42587 -2.20917 +276 1 5.11155 5.91401 4.29084 1.00396 1.28478 -0.181662 +277 1 6.86476 5.07118 3.47111 -5.70253 1.83988 -3.65428 +278 1 7.60709 5.97166 3.43329 1.57958 3.02153 1.22094 +279 1 7.62121 5.17116 4.25108 13.415 -9.76593 -1.32536 +280 1 6.90725 5.93696 4.35438 -12.0061 10.5099 -5.89092 +281 1 0.0158532 6.88433 3.5005 2.50125 -3.66413 -3.15884 +282 1 0.832759 7.6858 3.39159 0.810583 -3.83454 1.16734 +283 1 0.879361 6.87893 4.25184 1.06811 -4.80567 -3.71366 +284 1 8.48025 7.67569 4.32838 6.71448 4.3067 1.89144 +285 1 1.76699 6.83608 3.37875 -3.92913 2.06189 -0.762911 +286 1 2.64337 7.79272 3.38564 -11.5742 -11.6301 0.504133 +287 1 2.51611 6.79594 4.20547 2.9771 6.7763 8.40555 +288 1 1.73472 7.75634 4.30153 3.5376 -4.65751 1.06495 +289 1 3.42458 6.78486 3.36363 0.711862 2.92454 6.30952 +290 1 4.29146 7.78029 3.51531 3.92856 -8.43358 -6.61451 +291 1 4.22796 6.89496 4.356 2.49253 -3.58746 -4.19183 +292 1 3.49073 7.69895 4.31251 -15.4332 -7.21194 0.0843114 +293 1 5.03295 6.88949 3.43613 2.4132 0.715094 1.20127 +294 1 5.9914 7.60738 3.43115 0.166605 10.2994 10.8333 +295 1 6.06057 6.76316 4.28526 -0.682389 0.774521 0.518315 +296 1 5.1506 7.68481 4.35956 -0.587179 -0.831286 -4.17718 +297 1 6.91829 6.87557 3.41173 -2.20287 0.087574 0.74732 +298 1 7.77376 7.66664 3.47631 -5.20912 2.94829 -3.10686 +299 1 7.7733 6.85147 4.2793 -6.28798 -5.26886 2.97867 +300 1 6.79627 7.70864 4.34123 1.13479 0.471756 -2.41754 +301 1 8.47537 0.0666715 5.07785 3.07732 -2.35936 2.36099 +302 1 0.837862 0.824189 5.08442 2.67015 -0.0526079 4.2528 +303 1 0.947354 8.53746 5.97515 -9.44477 -2.06512 3.38353 +304 1 8.45527 0.903487 5.90211 4.35699 -8.49334 13.6006 +305 1 1.71466 0.0614796 5.21675 1.71751 -10.7388 -14.8483 +306 1 2.56545 0.785351 5.1483 1.0332 2.19745 -1.75997 +307 1 2.58448 8.48208 5.91956 0.430753 0.76971 3.58164 +308 1 1.65003 0.816215 5.93197 3.03102 12.7849 8.36083 +309 1 3.46033 0.0141985 5.16494 -4.25366 -0.783326 -0.484155 +310 1 4.20213 0.929517 5.13838 2.42665 -3.78185 -0.152962 +311 1 4.26733 0.0836521 5.92638 3.25998 -1.091 1.74874 +312 1 3.41102 0.861262 6.03148 -0.949591 0.0559607 -1.66554 +313 1 5.1564 8.53616 5.06672 -11.5945 -0.673098 9.37255 +314 1 5.94115 0.761043 5.20173 4.62182 33.122 -29.3364 +315 1 5.93463 0.0696556 5.8868 1.75697 -30.8547 30.3151 +316 1 5.14065 0.9256 5.95741 -0.006185 -4.789 2.4932 +317 1 6.91953 8.50208 5.18386 -10.6338 4.52372 2.129 +318 1 7.72317 0.898909 5.10883 -6.55365 -0.206627 -4.30053 +319 1 7.67728 0.0288812 5.99182 2.50541 0.776267 0.642418 +320 1 6.91834 0.891409 5.91811 -4.13582 -0.84176 -0.41985 +321 1 0.0355634 1.62397 5.15959 0.786537 13.0999 -7.10363 +322 1 0.855042 2.4658 5.05819 10.8208 10.8619 21.426 +323 1 0.798893 1.71459 6.01685 5.79471 -4.43182 -0.915803 +324 1 0.0659206 2.49237 5.91102 -5.57064 6.4328 0.916789 +325 1 1.77633 1.69788 5.04117 -5.55508 3.43302 7.46453 +326 1 2.55086 2.64298 5.08873 0.0193134 -8.77259 6.85672 +327 1 2.49765 1.63315 5.92814 1.12021 1.50275 1.88199 +328 1 1.80539 2.621 5.95731 -6.21714 -3.35524 -0.269961 +329 1 3.34329 1.63256 5.07699 -2.20219 4.06192 2.43743 +330 1 4.31458 2.52073 5.06335 -0.0632538 1.3392 1.20942 +331 1 4.33916 1.68863 5.97126 -3.41941 3.44417 2.01134 +332 1 3.42212 2.64548 5.89276 -0.0280586 -2.67425 3.44656 +333 1 5.16333 1.72803 5.18363 0.62931 0.268233 -3.53629 +334 1 5.97493 2.53755 5.18126 5.42417 -2.99996 -10.5798 +335 1 5.97644 1.77632 6.05208 2.30795 -0.932212 -2.38345 +336 1 5.20771 2.64035 5.9206 -9.19429 -1.91265 5.67918 +337 1 6.82113 1.7288 5.07227 0.319047 -2.27809 2.42075 +338 1 7.76584 2.66005 5.04767 0.36372 -2.98667 3.98468 +339 1 7.68048 1.73285 5.98682 1.83082 2.55026 -3.35109 +340 1 6.77723 2.66049 6.0628 11.9195 -28.0419 -0.192401 +341 1 8.52926 3.48894 5.20725 0.756027 -4.20422 -2.12394 +342 1 0.880496 4.18659 5.21886 -2.21024 5.88812 -5.98946 +343 1 0.823278 3.46696 6.03218 3.03891 -2.5906 1.31712 +344 1 8.45604 4.28238 5.97679 3.43734 -0.298701 2.3281 +345 1 1.66848 3.43018 5.1681 4.45896 -2.65722 -0.776378 +346 1 2.47623 4.29797 5.21376 10.0204 -9.1421 -8.64412 +347 1 2.46945 3.49538 6.0664 15.3766 -12.245 -4.5397 +348 1 1.75883 4.22715 6.00615 -17.7933 12.7993 4.23364 +349 1 3.32535 3.48763 5.18919 1.16348 3.11251 -2.54898 +350 1 4.29953 4.30461 5.21296 -7.48003 6.57243 -13.8987 +351 1 4.32836 3.50006 5.90127 -9.25916 -18.9556 4.88449 +352 1 3.45987 4.23872 6.06433 -4.26661 1.09432 -3.11516 +353 1 5.16317 3.46797 5.05136 -2.20358 -10.3645 8.38524 +354 1 6.01128 4.18674 5.11415 3.72823 2.851 1.21774 +355 1 6.05124 3.32995 5.89897 -17.0823 24.7049 3.10753 +356 1 5.05098 4.23901 5.94533 18.4684 10.5132 6.34816 +357 1 6.93195 3.37363 5.21832 -12.1973 3.61502 -16.8233 +358 1 7.67472 4.24466 5.1448 -0.046387 1.44369 -2.14451 +359 1 7.59877 3.3598 5.99617 16.3705 11.4653 3.48987 +360 1 6.9163 4.33093 6.01136 -0.884888 -0.827495 0.436994 +361 1 8.47485 5.1618 5.06757 4.58611 -6.95556 3.64111 +362 1 0.866551 5.92561 5.22826 -2.4458 0.731452 -4.83922 +363 1 0.856029 5.03088 5.93872 -0.961264 1.16585 2.50638 +364 1 0.025531 6.08363 6.03301 -0.603503 -3.86392 0.433571 +365 1 1.73882 5.05771 5.16436 -7.87894 6.49017 -0.085231 +366 1 2.54586 5.89415 5.04217 4.79689 21.4637 24.3945 +367 1 2.63875 5.11717 5.9033 -10.4096 0.222879 12.4433 +368 1 1.7282 6.02787 5.89482 3.82714 -3.17245 6.07309 +369 1 3.41343 5.11888 5.19776 7.89672 -3.25441 -9.4893 +370 1 4.34849 6.08405 5.13729 -6.43313 -7.37614 1.57014 +371 1 4.30919 5.18003 6.06007 -0.523489 -1.53897 -0.492658 +372 1 3.32135 5.97978 5.88753 6.80953 0.93257 3.29984 +373 1 5.2281 5.04347 5.09516 -5.81719 1.07839 6.76004 +374 1 5.94602 5.8851 5.09539 3.02249 4.44225 2.10278 +375 1 6.04092 5.17575 6.07061 0.50428 -9.39491 -12.3653 +376 1 5.21437 6.06631 6.06016 -6.35945 -8.11006 -13.4627 +377 1 6.91579 5.12007 5.08308 -5.11836 -4.49572 6.409 +378 1 7.70983 5.91053 5.07808 1.5309 9.32926 6.58643 +379 1 7.76683 5.15653 6.01534 -1.66429 -5.18049 -8.59085 +380 1 6.93784 6.03915 5.96221 -25.2768 -19.3137 -6.75792 +381 1 0.0625638 6.74931 5.10819 -0.676634 2.54846 -0.0250987 +382 1 0.86361 7.61298 5.03345 -2.5044 7.0388 6.38474 +383 1 0.851706 6.88156 6.03092 0.201379 -3.97494 -1.33706 +384 1 0.0506067 7.6425 5.89338 -1.769 2.22377 0.622415 +385 1 1.66322 6.86583 5.19561 3.09287 -3.33398 -7.05581 +386 1 2.62799 7.62451 5.17609 -27.9662 28.0267 -4.59006 +387 1 2.66202 6.83135 5.96842 -24.8289 -0.817724 19.495 +388 1 1.64735 7.66733 5.92394 4.49398 5.54382 1.70924 +389 1 3.32274 6.93842 5.22499 45.6897 -26.2601 -20.0997 +390 1 4.28266 7.68312 5.1494 -0.162983 0.307259 3.3477 +391 1 4.21122 6.74188 6.04596 -0.795282 5.66715 -3.63702 +392 1 3.40786 7.67271 6.05784 2.18013 1.35082 -0.335047 +393 1 5.13386 6.80127 5.05013 6.80473 4.27889 3.23937 +394 1 6.0188 7.62146 5.18796 -3.27693 10.2601 -11.1928 +395 1 5.9142 6.93974 5.96821 7.16288 -22.7812 5.828 +396 1 5.1207 7.60724 5.96887 -13.0365 8.36981 -2.80723 +397 1 6.90344 6.91817 5.14994 -0.204819 -5.34708 -0.858742 +398 1 7.6747 7.73724 5.15589 4.74286 -4.17129 0.509029 +399 1 7.64232 6.7419 6.03772 18.4896 23.5989 -0.89996 +400 1 6.75496 7.62762 6.01659 7.03025 5.11039 1.24431 +401 1 0.0963896 0.0201086 6.80553 -1.40648 -0.449972 0.0493894 +402 1 0.835843 0.891839 6.79877 7.20248 -7.32555 0.745706 +403 1 0.918901 8.53581 7.64787 -17.0565 2.54879 17.4592 +404 1 0.0577403 0.896342 7.73471 1.30728 -4.31515 -1.61795 +405 1 1.61051 8.45024 6.92242 29.7484 14.9171 -14.6755 +406 1 2.47578 0.885204 6.88627 1.39053 -1.86497 -2.40181 +407 1 2.50444 0.0274811 7.76899 5.04636 2.83552 -7.66004 +408 1 1.76075 0.832954 7.77629 -9.26653 -0.311946 -7.26081 +409 1 3.50837 8.51457 6.78791 -7.98313 -6.7176 0.868776 +410 1 4.17648 0.757665 6.93195 8.57719 11.9693 -2.56623 +411 1 4.23832 0.0657272 7.77237 -2.00114 -7.83956 -8.62893 +412 1 3.37339 0.86481 7.76894 -4.57993 4.49098 -10.8865 +413 1 5.14407 0.0592801 6.76072 -1.57797 -1.16589 1.03837 +414 1 5.93853 0.879814 6.88423 6.63031 -4.29327 -1.40131 +415 1 6.03919 8.48714 7.63222 -2.96915 1.1039 1.2166 +416 1 5.15255 0.794385 7.73799 -0.425319 2.1861 -1.28188 +417 1 6.89313 0.0918814 6.89086 -1.49841 -3.77335 -3.98868 +418 1 7.61212 0.939213 6.80354 8.77263 -4.1407 2.30253 +419 1 7.70899 8.53849 7.72172 -1.01623 -1.03696 -1.75272 +420 1 6.83169 0.853131 7.69229 0.514071 1.96118 2.47006 +421 1 0.0995377 1.63996 6.92907 -20.9698 6.48021 -16.3567 +422 1 0.856061 2.59196 6.8009 3.6314 -4.45866 -1.95318 +423 1 0.7986 1.79168 7.64825 21.262 -5.45904 12.6361 +424 1 0.086833 2.5674 7.63497 -11.6486 2.30739 1.5806 +425 1 1.65946 1.72494 6.90853 -2.96091 -3.71884 -7.8878 +426 1 2.55175 2.62076 6.77199 1.34599 -1.3093 4.14575 +427 1 2.49264 1.73911 7.61263 5.68035 -0.198489 5.50404 +428 1 1.73023 2.55227 7.60126 -2.61513 6.16936 5.4644 +429 1 3.34887 1.7831 6.78557 0.7181 -0.718938 0.35045 +430 1 4.23104 2.60662 6.78869 6.67274 -5.2978 -0.800832 +431 1 4.35855 1.74494 7.60411 -4.34125 -3.35913 2.62052 +432 1 3.36542 2.60589 7.78048 1.27821 -1.57097 -4.57229 +433 1 5.20004 1.65594 6.83168 -6.03666 5.50106 2.07188 +434 1 5.95504 2.56783 6.93549 0.704503 2.20695 -11.5481 +435 1 6.05448 1.73837 7.6627 -1.83376 -2.83098 2.15288 +436 1 5.1146 2.5438 7.6124 2.3372 -0.290906 4.36925 +437 1 6.88113 1.721 6.77631 -7.16431 5.43568 2.84999 +438 1 7.667 2.62761 6.74793 2.83097 -7.51196 9.4855 +439 1 7.73348 1.72515 7.754 -4.1563 0.657477 -6.03723 +440 1 6.7624 2.63316 7.64937 6.65302 -0.565372 4.94425 +441 1 0.0849859 3.37793 6.84942 -10.0386 4.11872 -3.53604 +442 1 0.857904 4.2895 6.93068 1.24699 0.504054 -2.41984 +443 1 0.822866 3.35005 7.62376 7.62204 5.76535 8.89189 +444 1 0.0609986 4.27823 7.72873 -1.62474 0.278416 -2.41968 +445 1 1.65771 3.45598 6.89789 2.67743 0.0202624 -2.34558 +446 1 2.54508 4.23374 6.86348 0.989961 3.94158 3.39783 +447 1 2.51344 3.50821 7.77131 2.79285 -8.19104 -6.06353 +448 1 1.76675 4.31871 7.74484 -7.62178 -3.47349 -5.94274 +449 1 3.46999 3.3444 6.87805 -6.49672 7.19856 -0.129806 +450 1 4.27761 4.20284 6.7963 2.00695 2.57497 4.55692 +451 1 4.36643 3.33193 7.71738 -5.18938 3.59254 -0.980407 +452 1 3.39117 4.21736 7.78484 2.56803 1.85612 -2.81745 +453 1 5.17851 3.50703 6.80054 -0.562057 -4.69817 1.35476 +454 1 5.91855 4.34694 6.82856 20.1656 -16.4219 -1.68121 +455 1 5.94421 3.41917 7.73472 -0.686701 1.44481 -0.413888 +456 1 5.21752 4.35256 7.70192 -2.57704 -7.73472 4.05334 +457 1 6.81349 3.41173 6.82265 -1.40277 6.3135 5.01717 +458 1 7.75813 4.35693 6.90395 -1.64702 -1.61669 -0.476323 +459 1 7.7614 3.35066 7.72289 -1.59004 1.58238 -2.0122 +460 1 6.90386 4.19648 7.73719 0.143217 3.47184 -3.3084 +461 1 8.51568 5.21538 6.91302 4.27065 -2.85002 -1.50895 +462 1 0.951652 6.01174 6.9207 -11.7991 -7.13131 -18.8927 +463 1 0.936182 5.16144 7.77632 -7.30596 -5.41004 -9.74737 +464 1 0.00163562 6.07485 7.63199 0.624183 -4.07361 5.99132 +465 1 1.66533 5.15284 6.74597 2.96466 -1.56742 2.06772 +466 1 2.61909 5.93515 6.89385 -1.40662 1.18192 -1.24787 +467 1 2.46927 5.13962 7.72554 6.76967 2.2802 -3.81441 +468 1 1.64453 6.02831 7.68681 19.7677 -7.24739 11.5441 +469 1 3.40343 5.06011 6.8889 -0.198511 0.401262 -0.796323 +470 1 4.30752 6.01937 6.85588 -10.789 -11.9311 3.49788 +471 1 4.28416 5.14222 7.62835 0.609452 -0.263512 0.8346 +472 1 3.47645 6.07368 7.70428 -7.22384 -10.7657 -0.906726 +473 1 5.22078 5.0656 6.90915 -18.0053 20.6161 -6.39 +474 1 5.99499 5.93089 6.77083 3.48021 13.0571 15.6598 +475 1 6.05342 5.21794 7.69617 -5.52282 -4.0969 2.40523 +476 1 5.15908 5.93838 7.59985 0.288818 1.34614 5.01043 +477 1 6.82844 5.21514 6.92244 2.6589 -10.3439 -6.80084 +478 1 7.65444 5.90306 6.73997 5.39846 9.09532 17.1635 +479 1 7.73871 5.1328 7.74827 -11.0217 0.411956 -11.9718 +480 1 6.85057 5.9849 7.66627 -2.19779 2.18231 4.19621 +481 1 8.49223 6.85953 6.88515 0.63092 3.61848 -3.8326 +482 1 0.912061 7.72558 6.80554 -14.7372 -15.0451 -0.530208 +483 1 0.94972 6.80465 7.60047 -8.86666 17.9559 7.11774 +484 1 0.0485157 7.69847 7.76952 0.871021 -3.29928 -3.01128 +485 1 1.7395 6.92207 6.74618 -0.216972 -4.99493 2.92958 +486 1 2.48517 7.73307 6.85664 4.02861 0.442708 -0.186237 +487 1 2.60224 6.86957 7.70226 -2.68029 -0.280597 -1.3011 +488 1 1.75659 7.71058 7.78997 -12.217 -12.015 -24.8657 +489 1 3.36601 6.81921 6.83807 2.83617 1.11452 1.50668 +490 1 4.30578 7.6333 6.9198 -11.3388 0.787746 -11.6868 +491 1 4.17656 6.84912 7.75346 9.62737 7.65922 -1.79281 +492 1 3.37828 7.72239 7.62462 0.544776 0.263736 1.68806 +493 1 5.03666 6.75188 6.83201 10.5371 18.8221 7.02157 +494 1 5.88561 7.69892 6.74579 2.44744 2.75196 7.83 +495 1 6.02886 6.89217 7.71335 -1.94107 -2.07696 0.28038 +496 1 5.05253 7.6432 7.63466 10.7152 0.484071 10.517 +497 1 6.76592 6.82276 6.85512 1.71624 -1.12004 -2.46021 +498 1 7.63682 7.73046 6.77254 1.37903 -1.27982 -0.239663 +499 1 7.60482 6.74157 7.76697 8.04118 12.5638 -12.9988 +500 1 6.86424 7.69163 7.60229 0.0588858 0.119654 2.66424 +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +500 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 8.2207069144348992e+00 +0.0000000000000000e+00 8.2207069144348992e+00 +0.0000000000000000e+00 8.2207069144348992e+00 +ITEM: ATOMS id type x y z f_1[1] f_1[2] f_1[3] +1 1 0.0109462 8.19276 8.15872 -2.39444 9.6729 7.55614 +2 1 0.913757 0.79291 0.0997863 -14.8553 6.06953 -19.2131 +3 1 0.922041 0.00329478 0.797424 -4.57303 -13.0314 3.29774 +4 1 0.0667547 0.768895 0.898382 -4.60646 8.57627 -8.38591 +5 1 1.74036 8.13245 0.0766359 -17.8989 17.5469 -5.09772 +6 1 2.47269 0.889925 0.0248853 -5.42566 -21.0007 -17.6291 +7 1 2.46322 8.1233 0.872599 4.75898 11.1097 -4.77186 +8 1 1.65846 0.837491 0.791152 15.1363 -5.40511 14.9864 +9 1 3.32881 8.19546 0.053156 -13.3342 -9.93994 -9.94684 +10 1 4.03279 0.760382 0.00184897 9.91793 7.67217 -5.53917 +11 1 4.13378 8.169 0.732239 -0.574085 -2.22965 11.4349 +12 1 3.20922 0.774467 0.746193 11.6707 -5.4973 20.7036 +13 1 4.84922 8.194 8.14339 7.30804 6.79019 8.16024 +14 1 5.8218 0.772541 8.17358 -10.0231 -1.2549 7.34514 +15 1 5.68256 8.16785 0.77714 3.02512 1.45358 -0.272422 +16 1 4.85759 0.84201 0.746179 4.61671 -0.701957 -1.77598 +17 1 6.62546 8.16087 8.21828 -7.1959 6.90651 13.7327 +18 1 7.47259 0.88807 0.0569708 -4.40901 -2.93179 -3.05075 +19 1 7.47431 0.0411346 0.771198 -11.1102 -3.58532 -4.76152 +20 1 6.57656 0.847149 0.913044 26.339 -17.4997 -36.7448 +21 1 8.18759 1.70398 8.18761 4.1072 -0.492398 0.811998 +22 1 0.899666 2.41042 8.17073 -11.5274 -4.75425 3.68191 +23 1 0.850302 1.72005 0.839978 5.34352 -14.6759 -1.78579 +24 1 0.0603398 2.39798 0.844681 -8.60658 17.5352 -6.64359 +25 1 1.71223 1.59237 0.0242378 -11.0164 14.7761 -6.28233 +26 1 2.39934 2.5183 0.00540478 8.02997 -3.83137 6.03634 +27 1 2.48112 1.56604 0.834626 2.61805 16.1266 0.364368 +28 1 1.6143 2.50502 0.831093 22.9512 -23.9291 -18.4162 +29 1 3.30714 1.5456 0.0352888 3.02185 20.9324 -4.02492 +30 1 4.17998 2.44319 8.21567 -15.5858 -1.30182 -5.2994 +31 1 4.13571 1.72982 0.900024 -11.4398 -17.9409 -9.12775 +32 1 3.31093 2.54257 0.820203 -10.3368 -11.5392 -3.6507 +33 1 5.0044 1.71067 8.16991 -2.52586 -20.2729 12.2321 +34 1 5.83707 2.42978 0.0552544 -9.07217 4.33101 -1.43054 +35 1 5.68958 1.61323 0.87339 20.6627 3.79367 -24.2404 +36 1 4.88712 2.41203 0.783075 18.227 14.4306 8.63131 +37 1 6.51234 1.55641 0.0925838 9.00513 9.77167 -3.15357 +38 1 7.38894 2.55021 8.21638 -3.89162 -5.39246 1.97695 +39 1 7.3932 1.68143 0.910549 14.6159 -16.4356 -32.9418 +40 1 6.52029 2.5195 0.875176 1.21021 -6.27577 -1.18313 +41 1 0.0178952 3.25358 8.17469 3.31384 23.2108 27.1434 +42 1 0.75874 4.10726 8.14569 6.02202 2.9315 8.91628 +43 1 0.895393 3.22207 0.752637 -27.1078 14.1691 0.641871 +44 1 8.18599 4.06691 0.900855 -0.259841 0.495686 -5.35481 +45 1 1.55285 3.22874 8.15747 6.98433 26.3863 8.64396 +46 1 2.49624 4.20319 8.19485 -11.6121 -5.75058 -7.87094 +47 1 2.42547 3.30302 0.888339 10.6882 -12.4594 -2.99107 +48 1 1.6862 4.0108 0.835279 -13.347 15.0654 -7.27246 +49 1 3.22 3.33904 0.0153378 4.70565 -17.4148 -11.2872 +50 1 4.15099 4.01359 0.0472035 -3.25232 -0.128895 -8.82814 +51 1 4.06799 3.24916 0.843927 9.3476 8.05351 2.04714 +52 1 3.19501 4.05 0.736238 12.2088 14.8797 22.981 +53 1 4.93359 3.21205 8.21538 5.02686 8.32666 2.39487 +54 1 5.81852 4.10681 0.0313505 -9.96067 16.6194 -8.35941 +55 1 5.78406 3.36669 0.776887 -2.74739 -9.47942 10.9149 +56 1 4.90983 4.0411 0.864362 0.837356 4.14382 -0.368312 +57 1 6.53897 3.36302 8.19911 9.90234 -20.173 11.5285 +58 1 7.46276 4.04697 0.0534703 -5.76424 1.73449 -3.50806 +59 1 7.34501 3.24442 0.827453 2.34892 5.8087 4.09531 +60 1 6.59021 4.15121 0.905225 -2.44603 -12.1461 -5.89568 +61 1 8.13258 4.93013 0.0905402 6.61239 1.0085 -5.83678 +62 1 0.918786 5.84938 8.18896 -100.34 -125.435 4.75603 +63 1 0.733666 4.90689 0.894865 5.0782 -1.1493 -19.9038 +64 1 8.13743 5.78012 0.885656 21.4143 -27.2006 -30.8387 +65 1 1.67225 4.91657 0.0765019 -6.36422 -5.41993 -9.68754 +66 1 2.43163 5.74665 8.16344 0.0454169 7.36314 0.282499 +67 1 2.52248 4.94902 0.779546 -17.0632 -3.92502 5.40756 +68 1 1.68817 5.73221 0.738326 -10.7061 -22.6586 25.0306 +69 1 3.20519 4.98792 8.20267 13.0471 -20.6699 18.764 +70 1 4.1645 5.8475 0.0144516 -41.0284 -51.2746 -22.2701 +71 1 4.12065 4.85332 0.726813 -6.7392 5.54296 9.04283 +72 1 3.22358 5.72978 0.902951 13.2902 6.38408 -11.6219 +73 1 4.86923 4.9681 8.18768 10.2044 -1.77915 -2.81852 +74 1 5.77301 5.70687 8.13281 -22.5863 16.9623 33.7246 +75 1 5.78731 4.97674 0.770243 -6.25016 -2.29075 -2.78772 +76 1 4.89256 5.78932 0.733037 29.9716 -43.8231 39.093 +77 1 6.61696 5.02048 8.19969 -11.3595 -28.891 -1.36328 +78 1 7.33645 5.74186 0.0277988 27.1444 12.1113 -11.7126 +79 1 7.32557 4.92161 0.798933 6.38759 1.63603 8.88722 +80 1 6.60198 5.76847 0.724174 -12.087 6.06842 22.1567 +81 1 0.0632305 6.4911 0.00261304 -6.53376 9.85675 7.22968 +82 1 0.730752 7.3973 8.19101 19.8665 -4.89129 14.6872 +83 1 0.894205 6.53954 0.906348 -15.672 -5.70878 -18.8817 +84 1 0.0916376 7.35116 0.914882 -39.3163 -12.8553 -54.9509 +85 1 1.54844 6.4779 0.0899714 109.204 121.919 -0.90408 +86 1 2.45374 7.43343 8.1677 17.1682 -16.9212 2.53497 +87 1 2.38485 6.48495 0.871503 16.8711 24.0952 -19.5071 +88 1 1.73482 7.30198 0.918245 -4.50526 25.4363 -21.6583 +89 1 3.35837 6.52948 0.00621289 -17.9347 4.05163 8.57797 +90 1 4.15544 7.30314 8.17418 -3.86421 14.3399 10.028 +91 1 4.18078 6.49797 0.807337 -33.0181 25.5019 29.3461 +92 1 3.28881 7.33369 0.840128 0.0678552 -0.60668 -1.16807 +93 1 4.86711 6.50097 0.0644243 55.2704 56.5162 -42.5456 +94 1 5.6807 7.37537 8.15497 2.37339 1.6253 6.06405 +95 1 5.83906 6.54647 0.813774 -8.31017 -0.439493 -0.862375 +96 1 4.90102 7.33548 0.785855 3.38301 3.17369 4.3776 +97 1 6.62594 6.60016 8.16507 -28.5529 -10.5165 29.461 +98 1 7.41236 7.32596 8.18119 12.8158 16.6867 22.5272 +99 1 7.48788 6.57526 0.906715 -17.6408 15.7915 -12.9219 +100 1 6.60846 7.32088 0.891813 -2.23221 1.45701 -6.99196 +101 1 8.17 8.13088 1.54543 21.7946 28.0076 23.7334 +102 1 0.889634 0.755106 1.5647 -2.22366 9.82139 12.4406 +103 1 0.787312 0.00367743 2.47285 9.7959 7.14049 -7.07183 +104 1 0.0399172 0.910289 2.54829 -10.4426 -54.7685 -48.8923 +105 1 1.70161 0.076186 1.70291 0.655659 -5.9987 -1.53887 +106 1 2.5425 0.840944 1.65312 -5.39214 -2.71573 1.42057 +107 1 2.39333 0.0846015 2.56412 19.1459 -13.6703 -26.8796 +108 1 1.62991 0.895915 2.55976 -9.37186 -8.23605 -42.2796 +109 1 3.3255 0.037006 1.60354 -4.30714 4.73223 -3.06839 +110 1 4.20236 0.841896 1.65063 -10.9567 4.39501 -2.76043 +111 1 4.12511 8.16508 2.38147 6.48597 31.2032 29.2026 +112 1 3.37125 0.822661 2.38548 -3.89508 0.169143 6.57094 +113 1 4.86677 0.028066 1.55007 9.3902 -7.55136 2.71818 +114 1 5.8528 0.805894 1.56988 -29.5994 -6.3857 29.2326 +115 1 5.73944 8.2048 2.38025 -0.334985 15.3443 16.2286 +116 1 4.92058 0.739392 2.48512 1.8123 5.57771 -0.399822 +117 1 6.61747 8.14877 1.63757 -7.92973 14.3058 -0.0863647 +118 1 7.37923 0.805843 1.70616 17.0436 -4.06349 -13.2175 +119 1 7.38533 8.17909 2.55221 2.10247 4.05286 -21.3656 +120 1 6.66981 0.91359 2.42776 -18.0385 -1.7859 9.16667 +121 1 8.21433 1.71804 1.64878 9.58557 -8.70073 -6.06848 +122 1 0.91795 2.50647 1.62107 -49.2165 -42.2319 12.3144 +123 1 0.778719 1.62612 2.3667 15.8366 8.16624 0.723179 +124 1 0.0388825 2.56454 2.43408 -0.65123 -11.9302 4.78295 +125 1 1.70614 1.64161 1.56714 -4.83448 1.54656 8.88708 +126 1 2.55772 2.51525 1.68348 -33.0305 -26.0768 -4.05159 +127 1 2.46774 1.68666 2.4295 -0.728639 -2.90689 1.14987 +128 1 1.58495 2.48207 2.53043 32.1395 -14.2129 -42.8967 +129 1 3.28639 1.69638 1.58862 0.141668 -5.07807 4.69228 +130 1 4.07581 2.46356 1.66204 5.75617 5.24573 6.028 +131 1 4.09064 1.65395 2.45941 5.06207 -1.15698 -3.64398 +132 1 3.2978 2.42597 2.51229 -0.392826 8.06961 -8.70923 +133 1 4.99952 1.60143 1.58928 -25.5713 -7.8385 22.8567 +134 1 5.66634 2.3835 1.71386 21.3679 17.6667 -19.1597 +135 1 5.74656 1.70527 2.50917 3.11288 -14.4009 7.07914 +136 1 4.97163 2.46224 2.45828 -14.3686 2.77193 11.4917 +137 1 6.62989 1.62285 1.56611 -20.0211 14.8617 27.1541 +138 1 7.37036 2.42163 1.58976 1.23932 26.194 15.084 +139 1 7.49234 1.71782 2.38524 -11.5645 -3.14792 16.0927 +140 1 6.57493 2.44646 2.50738 3.76278 -0.484364 -1.65815 +141 1 8.13855 3.28395 1.66364 9.95915 -4.6352 -13.1677 +142 1 0.822632 4.13968 1.61013 -1.66869 -18.1546 6.90643 +143 1 0.836195 3.27368 2.50106 -4.0013 3.27813 -2.23185 +144 1 0.00706469 4.04664 2.42415 6.78153 4.66429 11.0832 +145 1 1.56864 3.19926 1.57501 43.2252 54.2341 22.2486 +146 1 2.37435 4.19613 1.65007 19.5365 -23.6872 -5.11708 +147 1 2.53204 3.33272 2.45976 -10.1616 -1.37273 8.96239 +148 1 1.5958 4.02298 2.45513 4.44558 4.83545 -0.957126 +149 1 3.24862 3.20562 1.71329 33.7169 30.1535 -8.86948 +150 1 4.04966 4.11271 1.69147 14.455 0.133261 -16.0308 +151 1 4.17313 3.29199 2.42566 -5.80506 -5.3643 5.35172 +152 1 3.37886 4.04594 2.4591 -12.864 4.86539 14.8631 +153 1 5.00029 3.3715 1.7428 -16.124 -51.6521 -51.6846 +154 1 5.71525 4.10565 1.71106 18.126 11.5713 -25.6554 +155 1 5.67368 3.37853 2.52254 40.5036 -38.7002 16.4445 +156 1 4.98188 4.047 2.42098 -44.4942 70.6847 47.3189 +157 1 6.52567 3.216 1.71371 -0.385424 4.96723 -0.762826 +158 1 7.40007 4.08176 1.73877 -6.32286 -1.56827 -20.7524 +159 1 7.42837 3.30042 2.4503 -10.1629 -6.83382 9.16894 +160 1 6.52178 4.09551 2.40152 8.21405 -5.0269 3.15343 +161 1 0.00699263 4.85762 1.69229 -17.0824 5.05692 -6.94595 +162 1 0.756152 5.6631 1.60232 14.3979 15.6472 -4.59775 +163 1 0.764682 4.99903 2.39299 18.2885 -21.5851 21.4239 +164 1 0.0800264 5.75765 2.41619 -22.1201 11.2764 3.26076 +165 1 1.60226 4.84293 1.69094 -9.96687 23.2298 -5.36928 +166 1 2.38001 5.77059 1.56073 -4.13582 -26.0328 27.2432 +167 1 2.39304 4.87599 2.45449 3.86796 9.40324 7.0282 +168 1 1.5595 5.8443 2.45554 15.3251 -19.3503 -10.1983 +169 1 3.24805 4.8639 1.55208 5.72697 0.833939 9.91621 +170 1 4.12523 5.83768 1.72183 2.66681 -7.18069 -9.93584 +171 1 4.14719 4.98927 2.48442 -5.36599 -4.29088 6.08995 +172 1 3.29103 5.75037 2.41213 -9.14312 -21.8308 11.1485 +173 1 4.88531 4.96658 1.71552 5.62499 -3.03462 -8.19539 +174 1 5.80164 5.66001 1.66617 -22.0309 23.7646 0.752493 +175 1 5.79599 4.88622 2.4436 -18.3543 9.31939 -6.6266 +176 1 4.94007 5.78406 2.4889 7.47518 -6.1933 -6.95152 +177 1 6.50282 4.96059 1.57437 23.9581 -12.4339 8.07292 +178 1 7.43162 5.77666 1.60532 -16.9632 -9.02864 21.2089 +179 1 7.30902 4.88901 2.38072 1.39073 12.4251 10.603 +180 1 6.52191 5.81931 2.5443 7.19321 -57.902 -45.2674 +181 1 0.0825324 6.49799 1.58172 -0.0568703 17.3702 26.5223 +182 1 0.807327 7.40344 1.54436 38.413 9.53604 44.8678 +183 1 0.85313 6.5885 2.46372 -17.206 13.7674 -10.0743 +184 1 0.0766958 7.42441 2.49843 -14.0409 -5.69227 -10.6889 +185 1 1.56626 6.64679 1.65111 17.2201 -21.881 29.7832 +186 1 2.51758 7.48828 1.7101 -1.12703 -9.37355 7.34939 +187 1 2.48642 6.48139 2.37761 -17.45 9.10758 18.4987 +188 1 1.62607 7.39059 2.4668 5.47881 2.11068 -4.08662 +189 1 3.22096 6.48273 1.68127 15.0894 18.1205 -19.6751 +190 1 4.01435 7.47003 1.70259 9.92584 -36.0532 -31.9009 +191 1 4.01053 6.48307 2.56537 4.58494 43.5966 -38.8488 +192 1 3.31708 7.46346 2.49246 -11.1632 -6.704 4.9273 +193 1 4.97912 6.56412 1.70872 -0.0323444 1.40088 -5.51009 +194 1 5.76314 7.42951 1.73429 -4.71194 -18.4847 -18.3917 +195 1 5.75053 6.57569 2.52583 -15.5416 2.95473 -19.9489 +196 1 4.86788 7.33538 2.51839 21.348 1.25465 -21.9702 +197 1 6.54919 6.48383 1.72129 1.36669 8.74928 -8.3147 +198 1 7.40692 7.48075 1.59274 -4.17636 -24.5364 8.08039 +199 1 7.31105 6.49008 2.55841 18.9084 8.98379 -5.81349 +200 1 6.56124 7.4093 2.46898 3.88266 -3.866 3.64736 +201 1 0.0467578 0.0587236 3.25639 -2.58837 -3.06001 8.14477 +202 1 0.919472 0.840587 3.2901 -13.7955 -3.94396 11.0802 +203 1 0.913851 8.17129 4.10222 -17.0314 2.36091 -15.061 +204 1 8.12452 0.831674 4.11824 2.96137 1.66258 0.705395 +205 1 1.72266 8.12268 3.2983 -16.5809 -0.000561518 15.0322 +206 1 2.36681 0.848699 3.23189 33.3023 -3.20785 26.2082 +207 1 2.52451 0.093755 4.0501 -20.4816 -4.23237 16.7496 +208 1 1.57332 0.89934 4.17862 1.65408 -10.4059 -4.79402 +209 1 3.23411 8.18086 3.33998 20.9401 7.85353 -15.8307 +210 1 4.12777 0.912462 3.28751 -3.54395 -8.15241 -0.704223 +211 1 4.05479 8.16789 4.17086 6.43266 7.42359 -18.6916 +212 1 3.3412 0.763098 4.14988 -8.17365 16.5822 -19.2151 +213 1 4.85923 8.19378 3.30398 3.75427 6.29815 -1.39384 +214 1 5.723 0.836221 3.31262 4.07436 -7.7371 -12.3645 +215 1 5.78765 0.0695661 4.10746 2.41957 -4.40965 -1.14115 +216 1 4.97909 0.892899 4.12401 -13.5931 -16.8127 1.66952 +217 1 6.57108 0.0657357 3.30807 -10.4223 -10.045 -0.47006 +218 1 7.35373 0.738008 3.24493 15.9915 16.7978 9.43624 +219 1 7.34677 0.0332152 4.15763 12.3358 5.5849 -5.20193 +220 1 6.67147 0.918341 4.12524 -9.23951 -11.4667 0.577623 +221 1 0.0788919 1.58016 3.21314 -1.55258 49.5779 50.5391 +222 1 0.904188 2.40885 3.22233 -31.0956 -2.82504 30.7646 +223 1 0.877149 1.74225 4.15165 7.55452 -10.7555 -4.03202 +224 1 0.0936835 2.40444 4.16194 -19.0736 7.56858 -3.47745 +225 1 1.71236 1.61805 3.29179 -19.7602 28.7111 2.45155 +226 1 2.5486 2.41776 3.31547 -43.6679 25.9149 -16.2942 +227 1 2.39734 1.55251 4.06577 15.8032 7.53109 12.4652 +228 1 1.72237 2.5181 4.15876 -10.7679 -10.2774 -3.05137 +229 1 3.23039 1.71099 3.29502 25.8646 -44.0791 -9.55739 +230 1 4.12827 2.45813 3.1934 -6.48806 -10.3202 8.62038 +231 1 4.19407 1.63495 4.09603 -15.4993 6.39445 10.1662 +232 1 3.20761 2.36838 4.07177 19.5744 11.0493 29.9438 +233 1 4.94979 1.63514 3.37535 1.21152 5.67416 -27.5114 +234 1 5.82776 2.47766 3.34313 -3.66364 1.42568 -1.20833 +235 1 5.76542 1.58538 4.03513 14.4098 19.4192 12.2978 +236 1 4.95489 2.43394 4.07273 -1.13246 5.06376 7.36624 +237 1 6.661 1.60077 3.30919 -3.43354 8.94885 -5.94598 +238 1 7.49515 2.56092 3.28033 -10.5336 -12.2625 1.51454 +239 1 7.39275 1.71767 4.16117 3.5537 3.96098 0.811537 +240 1 6.54244 2.56469 4.20941 11.0399 -32.6669 -26.4629 +241 1 8.2116 3.30444 3.37137 5.74747 4.63382 -14.2394 +242 1 0.840624 4.14226 3.27407 -5.48884 -5.61804 0.498093 +243 1 0.734437 3.23139 4.08576 22.8281 5.93798 4.2063 +244 1 0.0471721 4.13123 4.11158 -4.3827 3.27424 0.087671 +245 1 1.70286 3.20807 3.23042 -2.96775 14.0769 10.9943 +246 1 2.38769 4.13105 3.27446 4.88078 -2.82576 -1.60425 +247 1 2.4087 3.28686 4.02353 16.6104 0.201322 7.1777 +248 1 1.69983 4.0678 4.13415 -10.6977 3.91895 2.19645 +249 1 3.34377 3.23634 3.36851 -11.3528 1.51526 -17.2895 +250 1 4.2055 4.03294 3.37597 -23.3492 5.34016 -26.85 +251 1 4.03955 3.26203 4.11941 11.7033 -4.94552 16.1773 +252 1 3.21963 4.01243 4.16102 5.66091 6.82551 -5.40832 +253 1 4.83261 3.19517 3.32313 20.1816 8.52525 -2.26656 +254 1 5.77148 4.16495 3.28824 -31.489 -26.7787 -6.90732 +255 1 5.82425 3.30115 4.19401 -37.1473 -6.40083 -11.3511 +256 1 4.87724 4.09609 4.11549 36.2568 -10.3151 3.06059 +257 1 6.58329 3.33973 3.22197 0.0461967 -7.66729 -2.40242 +258 1 7.43644 4.05966 3.30265 -3.56999 5.92726 -1.37248 +259 1 7.48286 3.29775 4.19646 -3.89008 -9.4431 -11.0777 +260 1 6.47907 4.03353 4.01383 29.8324 22.3851 15.73 +261 1 8.15241 5.02846 3.31122 10.6595 -5.28085 -5.36552 +262 1 0.804631 5.8376 3.20576 13.4276 -32.1322 14.0647 +263 1 0.877129 4.8969 4.13251 -1.47043 5.42126 -0.0257482 +264 1 0.0651636 5.75976 4.1954 -9.31697 -6.72952 -15.907 +265 1 1.57617 4.92532 3.28718 5.51341 5.68743 -3.59864 +266 1 2.42583 5.72219 3.30114 4.35376 1.25963 -4.44713 +267 1 2.4551 4.89394 4.08913 0.180251 2.9051 2.6698 +268 1 1.67099 5.80732 4.08057 -5.18981 -1.73911 5.86888 +269 1 3.33413 4.84944 3.32334 -2.55875 1.02427 -1.99572 +270 1 4.20493 5.83452 3.24979 -21.4386 -63.3893 34.6056 +271 1 4.19181 4.8901 4.01924 -15.0952 14.1984 13.5631 +272 1 3.36551 5.83759 4.08786 -9.40985 -16.2604 3.57159 +273 1 4.9921 4.89151 3.36329 -7.1819 8.21085 -25.7306 +274 1 5.77026 5.74279 3.2372 -19.2661 -13.3988 15.8911 +275 1 5.68576 4.90444 4.10854 12.1482 9.27276 4.35592 +276 1 4.84395 5.80423 4.20869 23.9245 -11.025 -23.296 +277 1 6.4858 4.83859 3.18898 36.5327 24.7135 15.3623 +278 1 7.30315 5.68446 3.36881 -0.385614 18.5722 -20.0571 +279 1 7.37309 4.9455 4.05168 -2.3203 -17.2743 20.9328 +280 1 6.63896 5.83294 4.18727 -7.1922 -10.1498 -0.517575 +281 1 0.0942908 6.52233 3.3159 -35.7657 14.4096 -15.937 +282 1 0.836387 7.40457 3.20726 4.47284 -0.4112 17.4557 +283 1 0.739312 6.64758 4.08638 39.4722 -18.3951 12.5032 +284 1 8.21631 7.30153 4.06221 -15.2581 27.9702 -0.672668 +285 1 1.58758 6.54973 3.25882 10.9016 11.7867 8.01769 +286 1 2.56536 7.3619 3.34369 -76.1678 6.55793 -73.9603 +287 1 2.52556 6.61112 4.10224 -30.5256 -34.6487 7.0656 +288 1 1.62124 7.32393 4.18622 0.536802 -1.56833 -6.92191 +289 1 3.3681 6.64037 3.37818 -8.53205 -51.1792 -62.7851 +290 1 4.15298 7.36163 3.20593 -21.9528 4.612 22.3686 +291 1 4.12464 6.54108 4.035 14.4356 20.1369 22.2034 +292 1 3.19906 7.31073 4.01315 82.3215 73.9575 117.35 +293 1 4.9065 6.52075 3.26638 28.3768 26.425 6.32862 +294 1 5.74138 7.36096 3.25092 -0.970474 8.69807 4.03129 +295 1 5.81652 6.58456 4.03756 -14.737 -0.580193 0.741413 +296 1 4.87586 7.39212 4.03191 6.20313 -4.00572 5.92319 +297 1 6.48611 6.49412 3.21889 20.5434 47.1119 52.8917 +298 1 7.41876 7.4098 3.23912 -0.409624 -8.77258 11.2401 +299 1 7.35972 6.63444 4.07034 1.58562 -5.33459 -2.2315 +300 1 6.64271 7.48657 4.18074 -12.6903 -3.8877 -6.90745 +301 1 8.18545 0.00495327 4.98201 0.835961 10.4978 -8.83054 +302 1 0.830861 0.760813 4.98094 -9.95647 8.66756 -7.1447 +303 1 0.808969 0.00641337 5.74397 -4.48252 1.30502 4.67537 +304 1 0.018812 0.795135 5.84676 0.988121 0.902183 -11.1018 +305 1 1.60862 0.0119183 4.84308 17.0508 -2.91068 17.4808 +306 1 2.50239 0.876955 4.96833 -9.09304 -5.08176 -4.69214 +307 1 2.44832 8.14323 5.81234 6.77585 9.13889 -19.0494 +308 1 1.56911 0.731109 5.75394 17.4698 11.7404 -4.99849 +309 1 3.28793 0.0458368 4.91142 -7.08209 -9.95818 14.0315 +310 1 4.07208 0.823519 4.87126 26.6153 -9.6486 13.2451 +311 1 4.06672 0.0477209 5.80002 10.3282 0.566915 -15.466 +312 1 3.2042 0.88056 5.78404 3.8932 -8.75566 -1.61055 +313 1 5.02696 0.0222739 4.88991 -12.0715 4.27124 3.2294 +314 1 5.73734 0.886325 4.85298 9.71713 -6.59089 13.6933 +315 1 5.79543 0.0389128 5.76135 -3.4407 3.92019 -0.496418 +316 1 4.85161 0.780997 5.82861 2.47749 38.2945 -34.2513 +317 1 6.64858 0.0906911 4.97808 -13.982 -18.784 -13.0607 +318 1 7.30429 0.900733 5.00382 63.7384 -13.5798 -32.445 +319 1 7.4114 8.15633 5.76261 6.64498 1.40027 -2.33346 +320 1 6.66824 0.783026 5.72649 -29.5414 5.85716 47.7215 +321 1 0.0281683 1.66949 4.95949 -0.425666 -3.96058 2.91208 +322 1 0.893447 2.47998 4.9969 -1.93266 1.10148 -5.4469 +323 1 0.843715 1.6221 5.7589 -0.766033 4.56211 -3.21682 +324 1 0.0782454 2.53663 5.73256 -1.35265 -11.3593 -4.90859 +325 1 1.65079 1.66704 4.93767 -0.533365 0.139965 4.11876 +326 1 2.51601 2.38441 4.90805 0.649871 6.98133 -0.140965 +327 1 2.41175 1.72195 5.72474 2.84663 -8.86686 7.73621 +328 1 1.61538 2.54316 5.81674 -0.089029 -19.7728 -12.4678 +329 1 3.35891 1.54703 4.95536 -9.48818 22.4331 -2.56554 +330 1 4.08195 2.54313 5.01426 16.1748 -2.70068 -21.0768 +331 1 4.12034 1.74262 5.81366 10.5637 -13.2904 -3.74489 +332 1 3.37175 2.4672 5.72729 -31.5422 -3.32565 13.6818 +333 1 5.0033 1.68848 4.95948 -13.0392 -13.8401 -3.80319 +334 1 5.66589 2.47997 4.89515 25.4212 2.24436 -8.70857 +335 1 5.79028 1.55903 5.82666 2.05757 18.2253 -24.3713 +336 1 5.0311 2.46113 5.68951 -16.9377 1.04 21.5338 +337 1 6.57827 1.56896 5.01204 -21.5711 32.5342 -4.2816 +338 1 7.31623 2.52382 4.98258 18.6955 -8.52314 -2.25127 +339 1 7.45461 1.64332 5.76278 -16.0261 1.47893 -16.982 +340 1 6.64089 2.42957 5.78128 -11.0128 0.688597 0.00936653 +341 1 0.0932375 3.33117 4.94446 -5.57952 -6.38154 1.87127 +342 1 0.757472 4.19176 4.95128 10.4651 -6.09524 -1.36969 +343 1 0.907905 3.31127 5.7437 -27.4593 -10.6172 -1.55436 +344 1 0.042027 4.05791 5.75958 -12.212 5.31553 -4.25834 +345 1 1.73758 3.25237 5.02547 -7.72352 0.251809 -15.9993 +346 1 2.4871 4.0191 4.9543 -17.108 24.4302 2.09179 +347 1 2.45668 3.23081 5.78465 2.15315 9.79763 4.28788 +348 1 1.58106 4.05092 5.80356 25.1427 18.6418 -4.49313 +349 1 3.19249 3.31456 5.03239 24.0259 -22.2006 -10.8088 +350 1 4.20707 4.15779 4.866 -22.1265 -5.11578 15.6203 +351 1 4.10653 3.22389 5.85277 -11.4198 11.552 -29.8203 +352 1 3.32529 4.01575 5.8236 -9.29377 10.539 -6.33768 +353 1 5.02426 3.35158 5.01899 -31.0395 -2.45923 -24.1365 +354 1 5.68644 4.17189 4.85403 7.36649 -6.63658 10.5871 +355 1 5.74132 3.29275 5.69662 23.2126 4.63385 22.4488 +356 1 4.92531 4.19073 5.71088 -1.56015 -9.54037 12.8094 +357 1 6.54444 3.23385 4.93781 3.72392 28.1796 29.5331 +358 1 7.41233 4.02229 4.92924 -1.20364 12.0626 9.54412 +359 1 7.4663 3.28529 5.82942 -29.7597 -4.87929 -37.7444 +360 1 6.60644 4.05138 5.75927 -5.95188 5.2753 -7.63938 +361 1 8.20344 4.97671 5.0085 -9.77785 -27.0171 -16.098 +362 1 0.764125 5.65629 4.97235 19.2848 26.171 -13.514 +363 1 0.873777 4.9677 5.68286 -0.798932 -14.5746 27.2238 +364 1 8.1297 5.72693 5.67887 36.2224 14.0656 51.1647 +365 1 1.7318 5.02959 5.01529 -5.49043 -14.6131 -16.8314 +366 1 2.44542 5.85219 4.93063 19.3822 -11.3762 -19.1618 +367 1 2.55143 4.96012 5.6972 2.49476 -2.70049 4.14057 +368 1 1.7425 5.82205 5.68004 -17.6493 -28.263 45.9708 +369 1 3.3219 4.92271 4.83646 -0.36054 0.182371 1.57441 +370 1 4.15401 5.67616 4.9285 -21.3575 6.09757 11.4691 +371 1 4.07715 4.94174 5.74451 -0.595544 -7.12056 -1.40506 +372 1 3.31639 5.79418 5.70206 -6.4923 -7.4901 3.07645 +373 1 4.92581 4.94202 4.97984 -0.22012 5.90431 -14.5879 +374 1 5.73821 5.69855 4.88283 0.98112 8.81137 -0.251897 +375 1 5.70683 4.9474 5.70386 9.48927 0.653977 8.8924 +376 1 4.96412 5.79635 5.67508 -8.29845 -17.1654 19.2091 +377 1 6.48765 4.91573 4.91811 9.87445 -1.02048 -0.929801 +378 1 7.42803 5.76565 5.01887 -36.8924 9.29378 -39.8178 +379 1 7.31535 5.01349 5.75729 -2.96639 -15.6116 3.19898 +380 1 6.51112 5.80276 5.76292 -0.511839 0.0343249 -1.86567 +381 1 0.0752499 6.50198 4.93503 -9.95853 14.5519 3.18185 +382 1 0.749032 7.44313 4.93057 9.36322 -4.26106 -6.17112 +383 1 0.799308 6.59761 5.72007 7.23025 -2.947 1.48543 +384 1 0.0646916 7.47006 5.72188 -15.7332 -12.5303 9.25543 +385 1 1.64476 6.54961 5.03014 -20.9538 30.4927 -38.3434 +386 1 2.45435 7.39325 4.88002 3.42796 3.8663 5.03137 +387 1 2.4342 6.59097 5.67369 23.2905 17.249 22.0616 +388 1 1.54778 7.4679 5.8363 19.3115 -12.9738 -21.1698 +389 1 3.32159 6.57391 4.94635 0.920374 5.37222 -4.76541 +390 1 4.12734 7.43087 4.87631 0.0949958 -12.9619 14.1535 +391 1 4.03648 6.57336 5.82487 9.67898 -2.57585 -4.33725 +392 1 3.37401 7.44443 5.83215 -8.90767 -10.0262 -16.7558 +393 1 4.95785 6.5313 4.96795 -5.28369 20.3288 -12.6073 +394 1 5.72446 7.44815 4.95617 -0.295615 -4.81227 -6.28599 +395 1 5.67507 6.56368 5.75557 19.5363 2.36566 3.12879 +396 1 4.99604 7.36578 5.82253 -12.0795 7.56208 -16.0156 +397 1 6.47952 6.65183 4.84549 7.81673 -1.192 17.7565 +398 1 7.49045 7.38842 4.86267 -3.31154 -1.72952 10.3926 +399 1 7.31515 6.64393 5.7627 1.65473 -7.46902 -9.80451 +400 1 6.51213 7.44705 5.67942 6.88055 -5.46286 6.12471 +401 1 0.0806264 0.0886591 6.67061 2.86389 -53.8636 -44.0246 +402 1 0.883633 0.899989 6.55658 -11.6958 -11.9156 5.39561 +403 1 0.88757 0.0447352 7.4623 -6.5852 -8.63148 -1.54458 +404 1 0.00589996 0.782701 7.30583 -3.57511 51.2033 48.3924 +405 1 1.70878 0.0185969 6.53425 -9.91562 -0.171369 19.1044 +406 1 2.47179 0.820184 6.65916 -10.0875 0.778119 -25.3377 +407 1 2.53937 0.0160974 7.34796 -3.95783 -6.52463 5.98309 +408 1 1.62994 0.765044 7.35659 9.0133 10.535 7.11032 +409 1 3.30704 0.041501 6.48376 -12.5346 2.59741 23.4233 +410 1 4.02443 0.849646 6.63591 28.9911 -27.1685 -8.99322 +411 1 4.05271 0.0416361 7.37632 0.533135 -1.75778 -2.17869 +412 1 3.19386 0.898466 7.37702 15.4736 -11.3366 18.5812 +413 1 4.93306 0.0872445 6.49555 4.8751 -33.7979 36.6921 +414 1 5.84884 0.883258 6.55834 -5.60524 -28.829 17.1111 +415 1 5.81564 0.024621 7.40384 -2.36039 -5.56484 -6.47242 +416 1 4.961 0.816895 7.40894 -1.64345 1.03662 -2.05135 +417 1 6.67176 0.000709987 6.50931 -8.49107 -0.789231 11.0199 +418 1 7.42872 0.868407 6.55728 -5.95092 -10.3429 1.39671 +419 1 7.36138 8.18623 7.46478 9.04825 4.48366 -10.7424 +420 1 6.59985 0.825831 7.39669 4.88737 -2.34866 2.27965 +421 1 8.14416 1.67759 6.49013 32.825 -1.32457 17.7447 +422 1 0.9037 2.40379 6.60352 -22.6991 13.3728 -5.6252 +423 1 0.83815 1.6821 7.34463 -6.45777 -9.82884 14.5288 +424 1 8.19206 2.55987 7.48041 1.09967 -24.6646 -31.5822 +425 1 1.61029 1.6565 6.61062 19.3859 -4.50632 -8.40911 +426 1 2.39042 2.47779 6.49991 10.3869 -7.14038 20.8685 +427 1 2.43336 1.66264 7.31159 -0.298923 7.67874 9.60508 +428 1 1.68521 2.53757 7.43341 0.0908995 -20.3899 -19.4953 +429 1 3.34574 1.55658 6.57542 -29.1499 40.141 -5.99747 +430 1 4.09567 2.50385 6.58715 2.92988 -17.1157 8.90269 +431 1 4.06967 1.60141 7.36073 8.28003 9.68724 13.2999 +432 1 3.26291 2.44686 7.41755 -1.72761 -1.27824 0.484775 +433 1 5.02343 1.63061 6.57358 -10.9076 3.24904 2.06921 +434 1 5.8117 2.52535 6.48584 -2.10788 -3.23133 8.48842 +435 1 5.76381 1.64883 7.37339 7.06147 -0.584215 3.21917 +436 1 4.99697 2.44099 7.45915 -1.75923 11.2498 -19.4182 +437 1 6.62044 1.59458 6.63611 -5.65576 11.9066 -13.6974 +438 1 7.40085 2.40641 6.52565 -4.26631 17.0681 5.6259 +439 1 7.4086 1.68173 7.30269 7.67403 -2.22025 20.1658 +440 1 6.56414 2.4958 7.48155 2.02857 -0.65966 -9.40352 +441 1 8.16172 3.22 6.50779 31.0613 6.17733 37.0029 +442 1 0.778923 4.13348 6.47989 7.10682 -1.13444 17.3069 +443 1 0.731543 3.38344 7.32104 8.57141 -10.8353 -0.596329 +444 1 8.20703 4.11651 7.39737 -10.5501 6.3503 -2.89453 +445 1 1.5556 3.22612 6.62242 10.8567 18.3759 1.80723 +446 1 2.43596 4.07218 6.65191 19.5996 1.93234 -23.7547 +447 1 2.42128 3.38357 7.48855 6.46322 -13.7769 -4.42002 +448 1 1.70183 4.1306 7.3251 -28.6202 8.98318 18.3174 +449 1 3.23368 3.21004 6.55845 -1.66335 0.810928 5.98502 +450 1 4.02817 4.01745 6.59179 9.73332 14.3603 -1.234 +451 1 4.04024 3.24371 7.33596 9.19519 -2.61436 13.2612 +452 1 3.33578 4.03204 7.3761 -11.8519 11.1256 7.31388 +453 1 4.84615 3.34919 6.50516 30.474 -3.21025 16.5113 +454 1 5.79338 4.10407 6.63223 -1.4488 4.34379 -6.9657 +455 1 5.71769 3.33306 7.36343 3.56485 -8.31237 5.17357 +456 1 4.89884 4.06687 7.36632 1.94898 -1.38193 2.81677 +457 1 6.61297 3.34048 6.58436 -38.9416 -40.8203 -5.50523 +458 1 7.30794 4.01061 6.56591 40.2005 61.5018 -17.6954 +459 1 7.37741 3.36957 7.31145 38.0889 -52.6112 27.9446 +460 1 6.66665 4.01974 7.42717 -35.3166 42.1921 1.19147 +461 1 0.0452175 4.90338 6.62118 -6.71352 5.92623 -3.01906 +462 1 0.869367 5.66645 6.62279 -29.6122 19.3042 -24.6336 +463 1 0.858776 5.03104 7.45654 -16.814 -24.2615 8.51744 +464 1 8.14658 5.74936 7.4724 2.5583 -5.40279 -7.71149 +465 1 1.59957 4.95319 6.53572 14.873 -15.6204 -6.12191 +466 1 2.54529 5.66468 6.59785 -23.4011 43.3591 -27.461 +467 1 2.4961 5.03005 7.34302 -11.668 -32.1864 28.6337 +468 1 1.60544 5.69113 7.30132 37.8442 13.2739 23.8753 +469 1 3.24356 4.96073 6.59142 26.8133 -25.0989 -5.08933 +470 1 4.09781 5.67439 6.52285 2.63557 7.15813 7.05447 +471 1 4.18105 4.86276 7.35501 -9.07005 4.72655 -1.53462 +472 1 3.36767 5.65499 7.49749 6.09099 26.0319 -27.9028 +473 1 5.01795 4.94278 6.59504 -2.00637 0.995546 -1.6799 +474 1 5.7841 5.85399 6.63871 4.06216 -12.0086 -14.5693 +475 1 5.83404 5.02565 7.38856 -29.8707 -40.8918 -9.03319 +476 1 4.9605 5.83878 7.31445 -12.603 -27.5006 25.6094 +477 1 6.59477 4.88222 6.67554 -4.07568 1.88148 -17.9737 +478 1 7.35313 5.77701 6.52551 0.181186 3.4052 7.13046 +479 1 7.348 4.89641 7.37973 13.5892 1.99375 8.82978 +480 1 6.49663 5.74982 7.4422 46.6685 29.9241 -18.7201 +481 1 0.0491078 6.53098 6.47716 -5.83531 -0.141054 6.60445 +482 1 0.791488 7.40292 6.50563 -8.70546 -0.874788 22.49 +483 1 0.919931 6.51323 7.45776 -11.5314 25.4002 -28.1718 +484 1 0.0481113 7.40468 7.43229 -11.5944 -5.37754 -18.7674 +485 1 1.63473 6.52345 6.62888 -0.301482 5.86022 -13.1885 +486 1 2.54325 7.3746 6.52095 -7.01617 -1.6126 8.94816 +487 1 2.42821 6.65367 7.34715 -0.0947462 -6.49261 12.3075 +488 1 1.66344 7.43005 7.38619 -4.64698 1.83667 -2.7903 +489 1 3.21223 6.51896 6.65614 12.5802 -0.344258 -7.45446 +490 1 4.18524 7.3836 6.50889 -0.948752 5.15796 16.6381 +491 1 4.03479 6.58867 7.43482 10.4531 -7.07785 -21.0648 +492 1 3.31132 7.44815 7.43351 -1.0832 -4.66317 -4.42978 +493 1 5.00814 6.58691 6.66459 -15.2308 20.9466 -24.4589 +494 1 5.70889 7.39626 6.56563 14.4769 6.85637 10.1092 +495 1 5.73775 6.567 7.43094 6.72915 9.63092 8.95959 +496 1 4.91068 7.49261 7.37168 0.330155 -8.28614 -9.94049 +497 1 6.53726 6.65021 6.66417 -1.59265 -6.08794 -3.67401 +498 1 7.37246 7.29875 6.57444 7.56141 13.3939 8.59342 +499 1 7.35261 6.58373 7.49207 23.0737 -16.5957 -35.2353 +500 1 6.60589 7.39349 7.49219 -10.7096 3.92482 -19.5185 diff --git a/examples/mdi/dump.17Jun22.series.driver.plugin.1 b/examples/mdi/dump.17Jun22.series.driver.plugin.1 new file mode 100644 index 0000000000..847432833a --- /dev/null +++ b/examples/mdi/dump.17Jun22.series.driver.plugin.1 @@ -0,0 +1,1527 @@ +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +500 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 8.9390353509656766e+00 +0.0000000000000000e+00 8.9390353509656766e+00 +0.0000000000000000e+00 8.9390353509656766e+00 +ITEM: ATOMS id type x y z f_1[1] f_1[2] f_1[3] +1 1 0.0109462 8.91109 8.87705 -0.258023 0.625273 0.429284 +2 1 0.983178 0.93542 8.91066 -2.88593 0.281032 -1.95154 +3 1 0.886776 0.00353842 0.964105 -0.27179 0.383251 0.443719 +4 1 0.0722273 0.817966 0.815708 -0.663834 1.25489 -0.35451 +5 1 1.82919 8.8603 8.91164 0.346262 0.966337 0.327185 +6 1 2.71374 0.850558 0.0977971 -1.53533 0.952301 -0.539148 +7 1 2.75443 8.9152 0.943835 0.200679 -0.0265554 -0.862232 +8 1 1.72161 0.971413 0.796705 7.79754 -6.0811 1.58835 +9 1 3.47837 0.0294075 0.0515782 2.76325 -2.21894 -0.80311 +10 1 4.43186 0.961325 8.89919 -0.387918 -0.444884 0.950878 +11 1 4.37764 0.00631327 0.801109 0.844344 -0.87322 -0.116598 +12 1 3.59567 0.80748 0.974874 -0.705778 1.85625 -1.80855 +13 1 5.35026 8.89566 0.0208816 -0.442875 -0.272596 -0.473028 +14 1 6.3022 0.978028 0.0782288 -3.05518 -2.94099 -0.889505 +15 1 6.27707 0.0297536 0.962734 -0.0515917 0.772188 -1.05602 +16 1 5.30223 0.918655 0.899444 1.33545 0.759601 -1.29769 +17 1 7.0769 0.0948096 0.0649153 0.098645 -1.06535 0.292165 +18 1 8.09537 0.913626 0.0774105 -0.154847 0.414543 -0.451754 +19 1 8.08165 0.0818588 0.895196 -0.689773 -1.28143 0.929968 +20 1 7.14638 0.885276 0.891299 0.487793 0.733541 0.918445 +21 1 8.89456 1.84483 0.0434425 0.886905 -0.621358 -0.495646 +22 1 0.935681 2.64324 0.0406455 -1.34335 0.213362 -1.25695 +23 1 0.966071 1.69976 0.948945 -7.88058 11.3257 -7.25569 +24 1 0.0121607 2.66637 0.881115 -0.232812 0.533689 1.18415 +25 1 1.85044 1.81859 0.00192994 -1.7495 0.19048 0.1992 +26 1 2.68148 2.7251 0.0685109 -1.25528 -0.916148 -1.01459 +27 1 2.62716 1.70715 0.839166 0.688023 2.33788 1.05919 +28 1 1.6905 2.59418 0.903739 1.58905 0.257971 0.508129 +29 1 3.57454 1.77719 8.88663 0.186742 -0.0628404 0.80372 +30 1 4.38099 2.63699 8.92556 0.253897 0.0578989 -0.178058 +31 1 4.45919 1.78484 0.892793 0.372262 0.580252 -1.28381 +32 1 3.55804 2.657 0.821946 0.208194 0.440929 1.42052 +33 1 5.39579 1.85576 0.0513097 -2.11231 -0.770148 -0.833202 +34 1 6.28486 2.68552 0.0861957 -0.390024 -0.099671 -1.25573 +35 1 6.16167 1.79587 0.852166 3.13123 -0.282736 3.8241 +36 1 5.43841 2.67896 0.926914 -0.906522 -0.132525 -0.585389 +37 1 7.09214 1.72405 8.83985 3.26876 6.20695 4.03515 +38 1 7.96694 2.76043 0.0935037 2.29966 -0.680397 -1.28039 +39 1 8.06525 1.69772 0.940378 0.498274 0.445905 0.0355574 +40 1 7.16698 2.58338 0.88179 -1.8895 -0.0707859 1.12114 +41 1 0.0210451 3.48041 0.0428158 0.862491 -0.329006 -0.681709 +42 1 0.874431 4.40275 0.0131769 0.218928 -0.148848 0.324321 +43 1 0.851364 3.60752 0.914082 0.352487 -0.527665 -0.410754 +44 1 0.0749717 4.51844 0.974577 -0.257295 -0.287753 -0.288054 +45 1 1.76248 3.58626 0.0539576 0.480316 -2.29368 -1.63127 +46 1 2.72367 4.4241 0.0474256 0.0272964 0.241712 -0.452415 +47 1 2.73289 3.61199 0.901343 -0.0645249 -1.94992 -0.502421 +48 1 1.8456 4.38069 0.843492 -0.349918 1.31176 2.27682 +49 1 3.50387 3.55674 0.0315796 1.56114 -0.0224047 0.116984 +50 1 4.49692 4.37908 0.0780585 -4.54206 0.213106 -5.58215 +51 1 4.46671 3.57478 0.880458 -0.334204 -0.938728 0.874478 +52 1 3.58815 4.43 0.950374 0.652985 -1.92511 -1.59862 +53 1 5.3866 3.58372 8.92789 -1.19711 -2.22155 0.617325 +54 1 6.17276 4.37217 8.86047 6.00842 1.34471 4.78274 +55 1 6.27432 3.53871 0.907449 -0.148389 -0.137473 -0.523414 +56 1 5.27909 4.47835 0.809401 8.23917 -3.14067 4.34956 +57 1 7.09737 3.53698 8.87413 0.14026 -0.233191 0.941929 +58 1 7.96586 4.56922 8.84208 6.8748 -6.48505 1.75868 +59 1 8.1189 3.63425 0.96148 -3.00277 -1.46323 -4.15536 +60 1 7.14279 4.43222 0.962078 -0.0459577 0.247999 0.321752 +61 1 8.89637 5.43177 8.92691 0.327116 0.812268 0.0679643 +62 1 0.854018 6.30348 0.0813318 1.06274 -7.24911 -7.87042 +63 1 0.873415 5.41923 0.812761 -0.31071 -0.409433 0.423823 +64 1 8.88236 6.35419 0.863575 -0.753758 -3.06962 -0.690381 +65 1 1.76334 5.40934 8.88249 1.8326 1.29836 1.91996 +66 1 2.68777 6.21767 8.90577 0.0461489 1.51967 -0.262666 +67 1 2.66088 5.41906 0.821357 0.262109 -0.890774 -0.241847 +68 1 1.86017 6.31332 0.804602 -1.38053 -1.13952 0.850174 +69 1 3.64435 5.42051 8.90358 -2.6101 -2.17442 -0.370474 +70 1 4.37466 6.25131 8.85278 3.71832 2.70453 0.946098 +71 1 4.53047 5.2708 0.824393 -3.54051 3.8431 0.931364 +72 1 3.61222 6.27635 0.96909 -4.05414 0.604922 -3.58471 +73 1 5.40042 5.34751 8.8935 -0.719369 -0.36085 0.212296 +74 1 6.18215 6.3156 0.0196993 0.267387 0.110688 0.223648 +75 1 6.27516 5.37868 0.90209 -1.0642 -0.241069 0.481931 +76 1 5.31268 6.25584 0.875522 0.133781 0.115172 0.026661 +77 1 7.20113 5.30633 8.84474 -4.87308 6.78349 0.0391413 +78 1 7.95512 6.30497 0.092705 6.00614 -6.0265 -0.649957 +79 1 8.08767 5.35538 0.811364 -1.15126 0.392579 0.741715 +80 1 7.08607 6.1919 0.926051 0.630581 3.46407 -2.46157 +81 1 8.92405 7.0566 8.88782 -1.53371 0.564813 -0.0213323 +82 1 0.905011 8.13513 0.0600006 -0.504969 -0.194195 -0.00181653 +83 1 0.816253 7.07033 0.801556 1.36958 7.74762 7.34595 +84 1 8.83925 8.07727 0.907684 2.46931 1.67506 1.17354 +85 1 1.86043 7.09328 8.91972 -0.773441 0.857837 1.39948 +86 1 2.76541 7.99166 0.0440794 -0.77809 1.05822 0.425741 +87 1 2.67654 7.18636 0.91183 2.62219 -2.00002 -0.219028 +88 1 1.8788 7.9677 0.915621 -0.894934 2.07357 -1.21117 +89 1 3.59357 7.13026 0.0332195 -0.388167 0.00237965 -0.544686 +90 1 4.38663 8.07233 8.88382 0.174711 -0.440379 0.0897133 +91 1 4.5359 7.22854 0.936578 -2.37627 -1.04519 -2.35662 +92 1 3.63538 7.97981 0.824881 -1.61206 1.29888 2.0997 +93 1 5.3271 7.23059 8.92328 -0.111431 -0.20975 0.289951 +94 1 6.30867 8.05581 8.84577 0.0946421 0.0525728 2.57365 +95 1 6.32003 7.15576 0.891457 -0.2569 -0.483959 0.0547371 +96 1 5.40661 7.9868 0.968462 0.415884 0.0845497 -0.268424 +97 1 7.22798 7.08713 0.0563741 -5.45853 5.72078 -0.51002 +98 1 8.05735 8.06186 0.0753342 -0.611004 1.73052 -2.95918 +99 1 8.10922 7.21906 0.806609 -0.400473 -2.4357 2.42821 +100 1 7.16998 8.08498 0.846622 0.253892 0.388538 0.000271703 +101 1 8.88419 0.00785958 1.88382 0.148531 -0.55276 -3.06718 +102 1 0.806706 0.963107 1.6981 0.146821 -6.1479 7.24676 +103 1 0.81371 8.93107 2.59291 1.58623 0.25767 2.66866 +104 1 0.0914118 0.851308 2.7806 -2.96193 1.34432 -3.85013 +105 1 1.70908 0.055279 1.86232 -0.26684 0.0875329 -0.306957 +106 1 2.72497 0.940903 1.70203 -0.757536 -0.918748 1.71384 +107 1 2.71129 0.0639965 2.67102 -0.311468 0.261861 0.646041 +108 1 1.73889 0.96912 2.64369 0.123913 0.173982 0.666446 +109 1 3.52533 0.0194588 1.83263 1.01391 -0.00454228 -0.284845 +110 1 4.50633 0.992013 1.70842 -3.51938 -2.99082 2.23564 +111 1 4.49463 8.9275 2.60712 -6.23135 -0.421499 6.59704 +112 1 3.51061 0.932206 2.63613 0.265327 0.172351 0.555119 +113 1 5.26459 0.0845656 1.88118 6.41483 1.44516 -5.35427 +114 1 6.26822 0.943133 1.78953 -0.172034 -0.0988047 -0.238973 +115 1 6.20352 0.0931252 2.63772 -0.251863 0.451194 0.97073 +116 1 5.33497 0.961022 2.74861 1.85573 -2.10168 -0.655218 +117 1 7.15143 8.91799 1.69931 0.631991 0.791476 -0.168042 +118 1 8.1075 0.884637 1.85069 -0.145764 0.238097 -0.736312 +119 1 8.10277 0.00424992 2.71008 -1.61591 0.00687295 -1.36275 +120 1 7.06485 0.985537 2.76239 8.19773 -7.92397 -1.18231 +121 1 8.91698 1.83538 1.78872 0.656642 -0.0731624 0.0431027 +122 1 0.901335 2.58954 1.84197 -0.375827 -0.324571 -2.7055 +123 1 0.839546 1.79651 2.68072 1.09251 -0.901613 -0.242728 +124 1 0.0205195 2.75315 2.62687 -0.478759 -0.0106512 -0.67727 +125 1 1.78258 1.70562 1.69835 1.31189 0.545066 2.20675 +126 1 2.77409 2.6552 1.77928 -3.71202 0.456863 -3.25075 +127 1 2.62583 1.79361 2.77487 3.4762 0.328618 -3.48584 +128 1 1.71155 2.69761 2.62919 0.862289 -1.38539 2.38335 +129 1 3.5477 1.79572 1.86096 1.43061 -0.605958 -0.978191 +130 1 4.46749 2.5924 1.76238 -0.0494618 -0.0821277 -0.176353 +131 1 4.52929 1.74324 2.59829 -2.00749 0.662049 0.061349 +132 1 3.48188 2.69682 2.61959 1.88694 -0.141301 3.78311 +133 1 5.34711 1.71486 1.76809 1.96327 2.17405 -0.830705 +134 1 6.24637 2.73306 1.80484 3.10489 -2.12999 -0.788559 +135 1 6.31443 1.71423 2.71392 -8.21546 8.18972 -0.602972 +136 1 5.26572 2.69815 2.75971 0.0267628 0.10355 -0.216257 +137 1 7.18953 1.75159 1.71849 -0.576203 -0.36263 1.38792 +138 1 8.05027 2.77408 1.76451 0.439173 -0.587966 -0.341117 +139 1 8.01591 1.69661 2.74434 0.366947 0.0491547 0.134545 +140 1 7.14772 2.69371 2.58907 0.0738449 -1.92773 2.13155 +141 1 8.86781 3.66165 1.74517 3.90719 -1.47472 3.87657 +142 1 0.936621 4.42773 1.79512 -0.401045 -0.147867 0.321366 +143 1 0.948846 3.59531 2.72105 -0.571635 -0.0105131 -1.06193 +144 1 0.0834486 4.38982 2.63588 -0.524533 1.06652 0.75481 +145 1 1.83432 3.4799 1.75691 0.359017 0.665628 -0.818381 +146 1 2.69175 4.37077 1.75144 0.14004 0.214725 0.925417 +147 1 2.74153 3.6404 2.67912 -0.708299 -3.83642 -3.24565 +148 1 1.87968 4.54846 2.67269 -0.684796 -0.993828 -0.138535 +149 1 3.5441 3.51573 1.77434 0.186245 0.881611 -0.696526 +150 1 4.55171 4.52396 1.79145 -2.75839 -2.91024 -1.57263 +151 1 4.49896 3.65335 2.59498 -1.96388 -1.7196 0.869652 +152 1 3.49741 4.47737 2.77344 8.37692 1.8085 -7.7175 +153 1 5.44145 3.48872 1.74764 -3.05421 3.82286 1.14399 +154 1 6.1743 4.53053 1.74574 0.463366 -1.70291 0.122224 +155 1 6.30198 3.67131 2.70975 -1.07292 -0.185523 -2.51985 +156 1 5.34196 4.38653 2.7007 1.29125 2.52938 -0.102964 +157 1 7.1691 3.54339 1.87445 -0.749456 2.7751 -2.56091 +158 1 7.97266 4.40051 1.79603 0.56071 1.27489 1.72891 +159 1 7.99234 3.49992 2.67525 0.940044 2.40885 0.128516 +160 1 7.18063 4.50303 2.68825 -0.923025 -2.40154 0.0954191 +161 1 8.91159 5.33038 1.82507 -0.0203349 -0.241672 0.333237 +162 1 0.8958 6.32359 1.78851 0.38501 -0.14702 -0.347965 +163 1 0.943571 5.31749 2.71754 -0.318578 -0.34148 0.397124 +164 1 0.0864418 6.28418 2.68726 -1.86154 0.137969 -3.27119 +165 1 1.71465 5.37463 1.6949 -0.232891 -0.268012 0.301526 +166 1 2.72852 6.31988 1.88644 -2.78715 -2.37305 -5.95735 +167 1 2.64735 5.41101 2.73193 1.7471 0.192556 0.973026 +168 1 1.84919 6.27948 2.72157 -0.39498 0.808971 -0.0974847 +169 1 3.48336 5.2657 1.71665 0.625214 2.24561 1.33995 +170 1 4.39296 6.19435 1.72952 3.81534 -0.586193 2.86006 +171 1 4.52517 5.37564 2.62027 -1.99502 -0.45422 2.59567 +172 1 3.56333 6.24537 2.5877 2.83084 0.938216 3.4987 +173 1 5.32581 5.29562 1.86847 5.13697 3.80601 -2.04537 +174 1 6.24758 6.22298 1.79203 0.477004 0.378689 0.56244 +175 1 6.25283 5.44934 2.73731 1.14422 -0.830366 -0.337224 +176 1 5.45416 6.25624 2.6996 -2.42774 -1.74418 -0.22606 +177 1 7.22676 5.41803 1.71412 0.223451 -2.28899 2.0191 +178 1 8.0979 6.3518 1.78861 -0.44204 -0.435572 -0.338725 +179 1 8.01325 5.26918 2.64973 1.18264 0.878361 -0.124926 +180 1 7.11991 6.34415 2.69936 -1.3293 -2.66755 2.78128 +181 1 0.0635545 7.11209 1.72165 -0.371894 2.049 0.790012 +182 1 0.857409 8.07873 1.82753 -0.608672 -0.60495 -0.46291 +183 1 0.930573 7.24697 2.65225 -4.55248 -4.69883 0.513873 +184 1 8.8491 7.95414 2.58819 0.570786 1.09764 -0.00497061 +185 1 1.71811 7.19809 1.77835 0.893245 -0.692356 0.118249 +186 1 2.78024 8.04523 1.70672 -2.88976 2.48107 0.040135 +187 1 2.67012 7.13476 2.61708 -1.16009 2.6938 3.43626 +188 1 1.72659 7.99584 2.64342 2.19305 3.0992 -0.0129086 +189 1 3.48631 7.23394 1.84989 5.35093 -4.92393 -2.00054 +190 1 4.4261 8.04744 1.77118 -0.338387 -0.0128497 0.448007 +191 1 4.41287 7.13619 2.73708 2.81119 1.17101 -3.79683 +192 1 3.52255 7.96143 2.73527 1.04353 0.896155 0.0445218 +193 1 5.31509 7.09458 1.73703 1.75862 -0.357986 2.37379 +194 1 6.31592 8.04277 1.87992 0.07968 -0.344084 0.021952 +195 1 6.19476 7.08883 2.7194 5.13464 2.37882 -2.53303 +196 1 5.31616 7.97076 2.64032 0.139732 0.0575338 -0.0995313 +197 1 7.13779 7.0901 1.87785 -0.856279 1.84142 -1.45962 +198 1 8.00182 8.12007 1.73344 0.812689 0.333431 -0.248462 +199 1 8.01591 7.08327 2.73264 -0.0756439 0.769292 0.331432 +200 1 7.15074 8.00152 2.76416 1.82643 0.942676 -3.56152 +201 1 8.89655 8.9304 3.48678 1.65951 -0.447815 3.8493 +202 1 0.950495 0.819015 3.5162 -1.29532 1.69106 1.16913 +203 1 0.81801 0.0539921 4.51501 3.2278 -0.258036 -5.15445 +204 1 8.85177 0.90744 4.37372 14 -2.90794 10.8129 +205 1 1.78019 0.0426842 3.56938 1.84169 -0.836001 -0.350651 +206 1 2.63146 0.926366 3.57031 0.012479 0.082004 0.331715 +207 1 2.70742 0.0633514 4.41591 -1.37547 -1.33331 0.456319 +208 1 1.7142 0.801654 4.43761 0.662356 1.10176 0.272549 +209 1 3.65397 8.84382 3.54877 -3.56671 5.39916 0.463391 +210 1 4.3911 0.894602 3.52171 0.595814 -0.346452 0.321605 +211 1 4.50401 0.046887 4.49909 -1.14502 -0.949582 -0.274225 +212 1 3.51809 0.843433 4.41351 1.90854 2.37085 -0.229306 +213 1 5.34066 0.0102546 3.52427 -0.108558 0.828678 0.2339 +214 1 6.2908 0.991162 3.59141 -5.23018 -9.53106 -1.9323 +215 1 6.23033 0.0280237 4.46344 1.30838 0.516693 -1.50043 +216 1 5.29132 0.919899 4.38256 0.973507 -2.91573 1.14051 +217 1 7.06389 8.92307 3.63529 1.41369 0.894395 -0.0234904 +218 1 8.13244 0.926287 3.63848 -11.0259 -0.689673 -11.6462 +219 1 8.07431 0.0396355 4.42295 -0.0998371 -0.343464 -0.2111 +220 1 7.15426 0.902415 4.51611 0.37609 -0.87238 -0.174942 +221 1 0.0547819 1.70767 3.52402 -0.0990054 0.634623 1.9504 +222 1 0.990251 2.59589 3.64321 -1.70133 -1.15531 -1.34459 +223 1 0.876254 1.75025 4.46545 0.108846 -0.46015 0.445192 +224 1 8.851 2.6248 4.52232 3.89545 -0.330965 -5.02573 +225 1 1.83233 1.81735 3.53725 -2.40083 -0.602726 2.24699 +226 1 2.73685 2.66072 3.63237 -1.34367 -0.0545412 -0.555358 +227 1 2.76889 1.75912 4.53924 -5.46261 0.887424 -6.31803 +228 1 1.79935 2.60963 4.48075 0.43952 -0.293553 0.768966 +229 1 3.51296 1.81737 3.56522 0.159577 -1.35984 0.863711 +230 1 4.48313 2.73941 3.65804 -0.990489 -8.98093 -5.87222 +231 1 4.37894 1.70897 4.40451 -1.1595 -0.0369555 -0.272198 +232 1 3.5578 2.69572 4.44594 -0.0317478 -0.740538 0.514717 +233 1 5.41644 1.73157 3.63972 -0.214907 2.94643 -2.78853 +234 1 6.22995 2.60145 3.56616 -0.0106554 -0.60109 0.383738 +235 1 6.30303 1.6885 4.42264 -3.32083 3.037 6.44969 +236 1 5.43404 2.73282 4.52181 -0.69148 0.715375 -0.475461 +237 1 7.08666 1.7162 3.65955 7.29974 4.17951 -2.48105 +238 1 8.0318 2.68816 3.49666 -0.181832 0.425298 0.461358 +239 1 8.08432 1.70749 4.5149 -2.31295 1.75558 0.820722 +240 1 7.18431 2.71452 4.51289 0.136997 -0.067144 0.521486 +241 1 8.84691 3.61245 3.64188 4.42683 -0.879675 -3.24184 +242 1 0.916797 4.43325 3.62545 -0.842258 -0.010797 0.0107287 +243 1 0.871748 3.60004 4.51194 -0.301498 0.107107 -0.324598 +244 1 8.92426 4.51452 4.44006 -0.00859866 -1.77564 -0.547037 +245 1 1.68965 3.48331 3.5995 1.50205 1.26015 1.14935 +246 1 2.74619 4.38356 3.49878 -7.16717 1.90489 10.07 +247 1 2.74519 3.65012 4.52097 -2.02388 -3.55766 -1.13857 +248 1 1.75432 4.38414 4.53252 -0.421779 0.409337 0.409015 +249 1 3.58997 3.49254 3.52387 -0.821723 1.10659 0.0739307 +250 1 4.40569 4.52296 3.53187 0.545495 -0.966363 -0.0502063 +251 1 4.38156 3.4874 4.39271 -0.289264 8.2647 7.79533 +252 1 3.54333 4.42257 4.55563 2.80723 11.1106 -9.83606 +253 1 5.27331 3.5295 3.65482 2.61308 2.66186 -0.969787 +254 1 6.16108 4.46828 3.59956 0.599894 -1.41883 -0.240371 +255 1 6.22639 3.63251 4.44985 -0.305031 -0.480252 0.0742084 +256 1 5.31568 4.40222 4.46767 -0.344747 -0.443719 0.00587924 +257 1 7.10015 3.56367 3.49443 2.55034 0.169304 1.35525 +258 1 8.02171 4.37546 3.5697 -1.76106 3.37709 -2.28074 +259 1 8.069 3.64942 4.40708 -2.31714 -3.33053 6.18677 +260 1 7.18438 4.37135 4.52245 -1.79563 0.274401 -0.392524 +261 1 0.0758128 5.3487 3.5652 0.184463 -0.360483 0.192319 +262 1 0.795174 6.30898 3.53894 9.14413 -6.75396 2.48214 +263 1 0.867482 5.30202 4.453 0.791187 0.0370161 0.388706 +264 1 0.00225224 6.31064 4.52093 0.402626 -0.0990512 0.0415993 +265 1 1.75224 5.26394 3.64332 0.696547 0.221295 -0.114908 +266 1 2.74065 6.24856 3.64631 -0.500385 1.40459 -1.64071 +267 1 2.73855 5.4528 4.44688 -5.40773 -5.67129 2.9343 +268 1 1.74472 6.17623 4.53641 0.82995 0.717951 -0.0718944 +269 1 3.48421 5.34442 3.61728 1.66736 -1.06074 -1.09811 +270 1 4.41383 6.35055 3.60638 9.51906 -9.2799 1.43724 +271 1 4.38632 5.26464 4.48258 -0.919101 0.504742 0.900072 +272 1 3.55793 6.1617 4.49469 4.34711 2.82736 -0.340092 +273 1 5.36863 5.28325 3.49178 -0.734818 0.617922 -0.744768 +274 1 6.26503 6.19943 3.66319 0.429882 1.55809 -2.03015 +275 1 6.35487 5.3413 4.44757 0.561767 -0.978785 -0.133344 +276 1 5.27408 6.24166 4.56754 6.98603 1.54355 -5.42942 +277 1 7.19701 5.44828 3.47564 -5.73363 -4.54905 0.0826653 +278 1 7.95668 6.19688 3.55501 6.31824 5.03885 -1.22951 +279 1 8.09251 5.32103 4.3972 -0.525971 0.388914 -0.470954 +280 1 7.21521 6.34275 4.38759 -5.30552 -2.8442 0.851377 +281 1 0.0775826 7.08234 3.53581 -5.46769 7.72822 0.0708503 +282 1 0.933572 7.95134 3.59844 -0.0755868 -0.81045 -0.0294233 +283 1 0.967321 7.07254 4.42487 -1.68738 -0.0136546 1.81969 +284 1 8.87247 7.95576 4.3937 0.743652 0.272325 -0.92866 +285 1 1.76917 7.11669 3.64005 0.930468 -0.723585 -1.50003 +286 1 2.76456 8.10499 3.62233 -0.317456 0.121935 0.766743 +287 1 2.61456 7.10311 4.56718 0.759736 -0.536182 -1.28605 +288 1 1.85332 7.96709 4.49102 -0.903085 0.0612931 0.171005 +289 1 3.6668 7.06536 3.52857 -12.7314 9.15268 1.72289 +290 1 4.37522 8.04334 3.61636 3.8155 -4.43194 -0.0509001 +291 1 4.53661 7.19684 4.42303 -0.089737 0.0836956 0.326132 +292 1 3.62847 8.06443 4.56174 -6.53673 1.14979 -7.53287 +293 1 5.44626 7.09379 3.53396 -2.70855 0.0837127 2.61511 +294 1 6.30058 8.08668 3.48692 -3.50797 -0.210369 1.40313 +295 1 6.24642 7.05504 4.56658 1.23504 0.486666 -1.51311 +296 1 5.40389 8.14153 4.41484 -1.1149 -1.90428 -2.07503 +297 1 7.0793 7.23572 3.56625 0.390898 -5.13728 0.366365 +298 1 8.02564 8.11993 3.55841 -0.989908 -0.0289504 0.0817166 +299 1 7.96341 7.11444 4.5691 3.18586 3.20848 -0.902141 +300 1 7.14662 7.9965 4.39373 -0.0363915 0.663241 1.28885 +301 1 0.0665117 0.0620058 5.29566 -4.76408 0.0634028 3.8487 +302 1 0.920378 0.847838 5.33345 0.704711 1.73157 1.07432 +303 1 0.90733 0.0507073 6.29492 -0.256865 0.383558 -0.568888 +304 1 0.0695806 0.935871 6.21245 0.520609 -0.18085 0.460935 +305 1 1.7158 8.90069 5.2688 0.480844 0.845699 -0.0820744 +306 1 2.72956 0.862321 5.35582 -0.666933 0.680843 -0.243728 +307 1 2.75788 8.89573 6.26927 0.729554 0.867268 -0.717865 +308 1 1.87787 0.918127 6.17945 -0.463015 -0.230718 0.375845 +309 1 3.57292 0.0827463 5.28099 -0.282881 -3.17985 0.660183 +310 1 4.39889 0.831174 5.46088 -0.653335 9.17872 -7.1909 +311 1 4.53367 0.077487 6.1821 0.157227 -8.03625 7.38236 +312 1 3.56635 0.935389 6.31146 0.221361 0.0036999 -1.2625 +313 1 5.44773 8.84526 5.27719 -1.51548 1.46139 3.00719 +314 1 6.272 0.802404 5.33609 -0.667532 1.91594 -0.251293 +315 1 6.22537 8.89219 6.16591 -0.245349 -0.895062 1.43446 +316 1 5.33827 0.94153 6.32303 -1.13614 0.583964 -0.338203 +317 1 7.11863 0.0577427 5.44516 0.0248025 -1.55594 -0.512164 +318 1 7.97781 0.796351 5.39903 0.844611 2.54625 -2.84321 +319 1 8.06017 8.92765 6.18069 -0.104306 -2.31947 1.77241 +320 1 7.18164 0.989783 6.31023 -0.163547 -0.192109 -0.79717 +321 1 0.0916103 1.88258 5.39516 -1.00186 -1.43206 -0.661702 +322 1 0.982314 2.60245 5.42151 0.964023 2.57135 -1.73713 +323 1 0.897632 1.84422 6.25233 0.598171 -0.657266 0.69786 +324 1 0.0925235 2.7239 6.16577 -1.60764 0.211114 1.61705 +325 1 1.82959 1.77578 5.39133 -0.293694 0.755656 -0.589776 +326 1 2.69272 2.74727 5.44011 1.7292 -2.84836 -1.30998 +327 1 2.6889 1.83234 6.17525 0.647659 -0.90616 0.231454 +328 1 1.77521 2.70825 6.28078 0.536701 -0.406727 0.0293567 +329 1 3.51954 1.69427 5.29216 6.69261 0.0739574 6.33581 +330 1 4.4097 2.73314 5.34432 0.344675 0.135757 -0.187596 +331 1 4.40444 1.82369 6.16689 4.836 -4.97823 0.364517 +332 1 3.67178 2.60038 6.25743 -5.49724 5.54416 -0.00203516 +333 1 5.35146 1.77827 5.39473 -0.235283 0.213892 0.835574 +334 1 6.28399 2.77802 5.42862 -0.340126 -0.250486 -0.411738 +335 1 6.23134 1.81375 6.22687 0.0223138 0.244736 0.523936 +336 1 5.32351 2.70513 6.28288 3.08354 -1.69468 -3.77436 +337 1 7.14617 1.80036 5.35567 0.0919136 -0.311209 -0.475968 +338 1 8.0974 2.70612 5.29285 -7.26474 -2.41437 5.10983 +339 1 8.1011 1.88391 6.31294 0.0553936 -2.83177 -2.84321 +340 1 7.18351 2.67214 6.17899 0.615225 -0.197791 1.28477 +341 1 8.87232 3.47935 5.28683 2.9021 4.26792 0.541835 +342 1 0.935261 4.37233 5.44726 0.629241 0.918492 -0.917538 +343 1 0.919878 3.52494 6.23281 0.869805 0.127506 1.01894 +344 1 0.00431382 4.37186 6.33532 0.0302966 1.00444 -0.578346 +345 1 1.87251 3.50381 5.42034 -2.4415 2.77086 0.0779929 +346 1 2.70362 4.48406 5.3041 -1.90814 0.882252 2.42793 +347 1 2.75055 3.50273 6.30756 -1.47013 1.25632 -0.795276 +348 1 1.84448 4.4497 6.22456 -0.665656 -0.501499 -0.145372 +349 1 3.61741 3.6732 5.27884 1.4909 -8.59965 8.97662 +350 1 4.55362 4.53069 5.43699 -1.55164 -1.28771 -1.47171 +351 1 4.52256 3.52483 6.1944 -1.86903 1.10409 1.578 +352 1 3.65361 4.51782 6.21866 -3.39722 -3.70857 0.481797 +353 1 5.32088 3.65892 5.41856 2.55855 -1.45769 -1.45685 +354 1 6.25422 4.4123 5.33119 0.406295 0.346858 0.292537 +355 1 6.15978 3.47786 6.34128 0.227911 3.77427 -2.75081 +356 1 5.33342 4.43001 6.30433 -0.582231 -0.0994195 -0.382533 +357 1 7.19473 3.56016 5.44441 -0.898652 0.294925 -2.64663 +358 1 7.98682 4.41046 5.33513 1.4916 0.0945815 1.20731 +359 1 7.97947 3.58929 6.2697 1.92008 -1.0462 0.640867 +360 1 7.19164 4.45465 6.22659 0.298273 0.832684 -0.26134 +361 1 8.91866 5.33922 5.43231 0.972904 -0.678404 -1.89043 +362 1 0.863832 6.24178 5.44793 2.40494 -1.34388 -3.01765 +363 1 0.840212 5.37684 6.26703 1.52144 -3.32025 -2.26664 +364 1 0.0375152 6.17563 6.19921 -3.52547 2.50803 1.96141 +365 1 1.71406 5.31325 5.33193 0.359992 -0.20317 1.05182 +366 1 2.70446 6.22369 5.28953 -1.67496 -0.128385 2.17513 +367 1 2.62094 5.31478 6.20919 0.620292 0.0770975 0.0647467 +368 1 1.78318 6.16446 6.20286 -0.707464 0.30734 -0.850222 +369 1 3.5001 5.34304 5.42111 1.18155 0.33408 -1.88423 +370 1 4.48409 6.21311 5.27474 -6.47906 -0.498054 6.10955 +371 1 4.40434 5.30746 6.24861 3.30032 4.47126 1.95885 +372 1 3.65651 6.23636 6.35732 0.258101 -0.821502 -0.539452 +373 1 5.37686 5.39062 5.45706 -0.495794 0.303868 0.87367 +374 1 6.27665 6.3275 5.44876 0.578726 -4.19567 -0.915026 +375 1 6.28987 5.34918 6.28481 -0.689441 0.646514 -0.025026 +376 1 5.38856 6.30438 6.29204 -0.62461 -0.174266 -0.144794 +377 1 7.10303 5.36134 5.39788 0.303084 -0.453051 0.575398 +378 1 7.97278 6.2689 5.34555 1.29349 -0.0892034 0.239307 +379 1 8.1123 5.2681 6.25774 -0.648694 -0.661016 0.761589 +380 1 7.23419 6.34793 6.22344 -1.98134 -0.75315 1.10815 +381 1 0.0530217 7.08624 5.43675 -2.76329 0.356415 -1.34254 +382 1 0.891502 8.07734 5.33574 -0.449954 -0.433341 -0.0145848 +383 1 0.859902 7.08778 6.21702 1.22817 0.316603 2.39974 +384 1 8.86723 7.96664 6.28254 0.557062 3.16551 -3.15026 +385 1 1.77928 7.05564 5.34292 -1.2854 -0.797113 0.726349 +386 1 2.74792 8.05162 5.34603 0.580474 -0.247926 -0.00393627 +387 1 2.61984 7.13654 6.2076 0.1179 0.00397349 -0.327299 +388 1 1.73531 7.99204 6.32624 -0.619957 1.84241 -1.57732 +389 1 3.59984 7.17613 5.43634 -0.452415 0.706682 -0.14784 +390 1 4.39821 8.05962 5.28157 7.32724 0.749963 7.12774 +391 1 4.53389 7.20586 6.21186 -1.71384 -1.49003 0.809357 +392 1 3.66572 8.09269 6.23368 0.381787 -1.59697 -1.53597 +393 1 5.43811 7.11751 5.40192 -5.5589 -0.00418968 -4.06356 +394 1 6.35445 7.96959 5.31467 -2.59984 2.44569 0.360222 +395 1 6.17375 7.13942 6.18142 5.31103 3.8936 7.8957 +396 1 5.29125 8.02549 6.29493 1.99742 1.43167 0.441829 +397 1 7.11664 7.15874 5.38774 1.63444 -2.12611 -0.430051 +398 1 8.12983 8.0005 5.26693 -0.350623 0.791023 2.07438 +399 1 8.11089 7.10521 6.29529 -1.02761 -0.414645 -0.639575 +400 1 7.1542 8.04467 6.33119 -0.716395 -2.97685 -2.97233 +401 1 0.0455321 0.0581059 7.13785 -2.59331 -3.08955 0.589456 +402 1 0.853998 0.797568 7.23372 2.25232 12.9399 -9.25923 +403 1 0.893883 0.0531987 7.95582 -0.265032 -9.78891 10.4341 +404 1 0.0979374 0.927475 8.08374 -1.27945 -0.625441 0.909779 +405 1 1.70883 0.0184568 7.15475 0.947479 -0.211015 -0.0644084 +406 1 2.65212 0.910749 7.07723 -0.301347 -0.213339 -0.337826 +407 1 2.6305 8.90469 8.0727 2.55272 1.71066 0.384582 +408 1 1.75018 0.91387 8.02574 -0.526684 -0.686186 -0.483147 +409 1 3.61403 8.84934 7.06612 1.02988 1.44024 1.76178 +410 1 4.42034 0.91943 7.17223 0.522178 -1.61468 -2.10925 +411 1 4.37056 0.0516865 8.14003 0.0263315 0.189467 -0.466418 +412 1 3.59 0.934896 8.00045 0.0371044 1.00787 1.05016 +413 1 5.2816 0.0108877 7.14004 0.0410715 -0.366939 -0.311788 +414 1 6.23624 0.898837 7.05965 1.021 0.941131 0.654753 +415 1 6.246 8.87468 8.06175 -0.280098 0.535663 -1.1759 +416 1 5.31648 0.815501 8.12607 -0.78801 0.243527 -0.599256 +417 1 7.10707 8.84874 7.08197 -0.468775 2.08644 1.86713 +418 1 8.05013 0.946529 7.22788 -1.5208 -0.582053 0.186559 +419 1 8.1301 8.84043 8.01457 0.052244 0.715074 -0.282442 +420 1 7.06838 0.987221 8.03414 10.0415 -13.6791 -1.19755 +421 1 8.86835 1.70934 7.22731 2.54892 2.22649 -0.22541 +422 1 0.866325 2.76414 7.15029 -0.0137847 -2.49225 -3.8584 +423 1 0.826708 1.83336 8.03111 1.70357 -1.53255 0.309164 +424 1 0.0511912 2.65175 8.02861 -1.53037 1.53618 -0.152554 +425 1 1.7237 1.71044 7.1133 -0.3904 -0.435435 -0.731182 +426 1 2.66636 2.72018 7.14295 0.547793 -0.274295 0.648117 +427 1 2.70105 1.80209 8.13576 -0.0852062 -0.133841 -0.000493208 +428 1 1.77492 2.76081 8.10399 0.564357 -0.308093 0.985398 +429 1 3.66205 1.87543 7.16799 0.15905 -2.5091 -2.55207 +430 1 4.55348 2.70177 7.05301 -5.50098 -2.53366 3.01389 +431 1 4.46818 1.71608 7.96441 0.32513 1.80226 3.00161 +432 1 3.56091 2.58808 8.02945 0.396266 1.95642 2.12785 +433 1 5.36149 1.84637 7.16969 0.516803 -0.0610583 -0.802699 +434 1 6.28291 2.77184 7.1854 -0.512674 -3.17359 2.22694 +435 1 6.3427 1.71551 7.9726 -15.2061 11.4078 1.6664 +436 1 5.45463 2.61593 8.09933 0.73198 1.12429 -0.810915 +437 1 7.14617 1.80598 7.24022 4.03182 0.503759 -4.81039 +438 1 8.07521 2.6756 7.07092 -0.336894 3.22322 3.478 +439 1 8.11875 1.8373 8.10797 -1.57974 -0.493075 -0.537868 +440 1 7.09714 2.63714 8.02739 -0.0173147 0.820696 1.90431 +441 1 8.85027 3.56499 7.15253 3.00565 -1.27064 -0.682205 +442 1 0.885235 4.38222 7.18774 -1.842 1.22146 -0.226395 +443 1 0.884771 3.48141 7.97536 -0.530218 4.3971 3.23625 +444 1 0.0419078 4.41462 8.04436 -0.806344 -0.262731 -0.956831 +445 1 1.73746 3.66699 7.09267 1.85773 -3.96877 -1.41987 +446 1 2.66489 4.55163 7.19564 0.399017 -1.47837 -0.325749 +447 1 2.68401 3.61278 8.06372 0.262338 -0.0680464 0.329915 +448 1 1.80878 4.38262 7.9551 -1.46544 1.49945 2.09645 +449 1 3.55441 3.63471 7.17184 -0.0924634 0.45212 0.606799 +450 1 4.40759 4.53436 7.23701 0.160045 0.252781 -1.03281 +451 1 4.47938 3.49218 8.04219 0.177099 0.0940276 0.00712601 +452 1 3.55379 4.48752 8.06012 -0.927856 0.341505 -0.0833457 +453 1 5.30335 3.52949 7.1279 2.00125 1.71282 0.0663191 +454 1 6.19233 4.44015 7.09395 -0.123778 -0.82645 0.684973 +455 1 6.31698 3.55227 8.05766 -1.80584 -0.932697 -1.1518 +456 1 5.41804 4.43351 8.09204 -4.30063 -0.218755 -3.96516 +457 1 7.232 3.50321 7.24512 -0.569054 0.129485 -1.05452 +458 1 8.04777 4.39134 7.10023 -0.415559 1.27013 1.1937 +459 1 8.09921 3.54644 7.99275 -0.904288 0.185761 1.62031 +460 1 7.15284 4.38151 8.0646 -0.281528 0.0795406 -1.17401 +461 1 8.85944 5.36104 7.19522 1.71386 -0.372777 -2.67299 +462 1 0.808445 6.15874 7.05432 0.343929 1.70028 2.25424 +463 1 0.99266 5.36055 8.05319 -1.96195 -0.361049 -1.35199 +464 1 8.9228 6.22111 8.03716 -0.328906 0.253391 -0.16959 +465 1 1.7511 5.27554 7.16317 -0.501838 -0.493478 -1.59379 +466 1 2.7323 6.31099 7.08452 0.463177 0.0720173 0.389338 +467 1 2.75106 5.38162 8.09911 0.530948 -0.923774 -0.761524 +468 1 1.80446 6.33727 8.00982 0.567564 -0.353842 0.999402 +469 1 3.53218 5.32026 7.15711 1.3552 1.44822 0.141569 +470 1 4.49512 6.19462 7.20137 -2.95094 2.57244 -4.09211 +471 1 4.4829 5.43783 8.04952 -1.75843 -3.70774 -0.194014 +472 1 3.65767 6.24252 7.97233 -2.18137 -0.334806 -0.189717 +473 1 5.35752 5.46295 7.14871 1.05371 -2.23541 -1.50951 +474 1 6.22804 6.29485 7.12141 -0.370188 0.264704 -0.149428 +475 1 6.34127 5.4593 8.01496 -0.759119 0.239406 -0.0100712 +476 1 5.27101 6.21963 7.98358 4.21356 3.70888 3.53999 +477 1 7.2413 5.39744 7.15422 0.63332 0.408861 0.0765336 +478 1 8.01209 6.33115 7.20214 1.04149 -1.50251 -0.643312 +479 1 8.11155 5.33363 8.02803 -2.08279 1.51127 0.153008 +480 1 7.20203 6.31049 8.06426 -0.105023 -0.935886 0.140492 +481 1 8.92362 7.24394 7.10015 0.0792153 -3.18157 4.09933 +482 1 0.865164 8.02092 7.22606 2.85769 1.65383 -2.61434 +483 1 0.86745 7.15339 8.01815 -0.578541 -0.380635 0.364655 +484 1 0.0284189 8.08161 7.95725 -0.890268 -0.349283 1.10066 +485 1 1.85656 7.22057 7.11535 0.397315 -1.70504 3.16253 +486 1 2.77375 7.96501 7.15423 0.0953595 0.0574297 -0.272157 +487 1 2.64437 7.22314 8.11966 1.48696 -0.179689 -2.12782 +488 1 1.85941 8.11413 7.96635 -2.35368 -2.50728 -0.754549 +489 1 3.67468 7.10829 7.12824 0.65987 0.70298 0.656082 +490 1 4.46621 7.99739 7.2078 2.25404 -0.456947 -2.59682 +491 1 4.48001 7.09955 8.01357 0.0334801 0.324585 -0.290932 +492 1 3.6378 8.02597 7.95299 -1.96867 -0.619231 2.20677 +493 1 5.31589 7.17259 7.15585 0.23145 -0.930936 -0.437425 +494 1 6.20936 8.03122 7.09513 -0.13604 -0.296447 0.152582 +495 1 6.17543 7.22187 8.09898 5.44884 -7.61495 -1.62058 +496 1 5.43883 7.98222 8.0181 -6.37262 6.00913 -1.00537 +497 1 7.14576 7.09705 7.14015 0.407174 1.49093 0.0363952 +498 1 8.02588 8.07609 7.1284 1.43118 -1.40285 -0.689018 +499 1 7.99317 7.15919 8.00286 1.19218 0.601266 0.682892 +500 1 7.2435 8.04597 7.97482 -1.89044 -0.246287 0.1524 +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +500 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 8.5498797333834844e+00 +0.0000000000000000e+00 8.5498797333834844e+00 +0.0000000000000000e+00 8.5498797333834844e+00 +ITEM: ATOMS id type x y z f_1[1] f_1[2] f_1[3] +1 1 0.0109462 8.52194 8.48789 1.60777 3.16074 4.93288 +2 1 0.770239 0.886587 0.0775241 5.1148 0.619933 -4.35337 +3 1 0.914855 8.54009 0.795212 -2.54709 2.40671 3.27622 +4 1 8.53949 0.79582 0.824294 -1.87361 -0.316163 2.22706 +5 1 1.68126 8.45058 8.49491 -0.796772 17.9401 13.8601 +6 1 2.49257 0.906431 0.000759221 8.8197 -0.476032 2.96817 +7 1 2.62932 0.0354753 0.888378 -4.43263 -0.45206 -5.76212 +8 1 1.71329 0.913566 0.778252 -3.74188 -4.37189 3.26227 +9 1 3.42175 0.0965993 8.49503 -4.75784 -8.08943 10.1901 +10 1 4.21271 0.889278 8.46971 8.07159 3.26979 7.09905 +11 1 4.30903 0.0721078 0.771319 -2.20196 2.16322 3.01896 +12 1 3.42332 0.912751 0.876126 -1.2014 -0.27869 -2.68959 +13 1 5.04057 8.48132 8.46735 12.114 4.06773 4.60111 +14 1 5.95626 0.830289 0.0884189 2.64036 5.56585 -7.9642 +15 1 5.95178 0.0392781 0.802073 0.496214 -5.11156 5.55524 +16 1 5.1151 0.919125 0.80056 -4.53937 -3.75487 2.57161 +17 1 6.8031 8.46299 8.54479 -1.12262 1.88258 -1.67969 +18 1 7.77702 0.837169 8.46101 -2.81144 0.601723 4.97774 +19 1 7.61766 0.0190488 0.807902 2.02145 -3.01975 -0.996798 +20 1 6.83813 0.841817 0.893784 2.20091 1.15146 -3.46095 +21 1 0.00483518 1.7748 8.45086 3.14001 0.0124508 7.14446 +22 1 0.925315 2.54775 8.47859 -2.14676 3.17757 1.68537 +23 1 0.946475 1.73152 0.932031 -7.90083 -3.0997 -5.49951 +24 1 0.0820864 2.59152 0.95052 -16.5003 -1.1863 -19.4267 +25 1 1.62363 1.68342 8.4651 1.8496 1.86303 2.33818 +26 1 2.56251 2.66233 0.0202936 -6.7309 -4.60627 -0.0436147 +27 1 2.47347 1.71611 0.900003 2.27232 1.93928 0.205074 +28 1 1.66562 2.5538 0.89239 8.29789 -0.0162708 -2.14995 +29 1 3.47808 1.70927 8.49067 -6.21947 -0.00998514 1.91211 +30 1 4.19294 2.51037 0.0787296 16.1199 8.28753 -17.6776 +31 1 4.29711 1.73051 0.787489 0.142042 -5.75402 7.11231 +32 1 3.43681 2.6439 0.75999 -11.309 -9.11906 21.9869 +33 1 5.20599 1.76704 0.0398807 -10.2389 -11.7619 -5.76949 +34 1 5.91436 2.52733 8.51501 10.4145 9.83206 -1.49498 +35 1 5.9033 1.67223 0.919622 10.1161 4.25667 -5.1777 +36 1 5.15205 2.55373 0.788133 -1.76953 2.31199 6.90362 +37 1 6.92232 1.70971 0.0701593 -2.50899 -1.62202 -0.822044 +38 1 7.5955 2.61765 0.0592135 2.55821 0.640647 0.0382532 +39 1 7.74881 1.7729 0.896218 -1.59166 -5.96851 -6.46077 +40 1 6.80231 2.56106 0.910949 5.84287 -4.44794 -4.99646 +41 1 0.028349 3.48236 8.49963 2.5025 -5.04288 3.39467 +42 1 0.836484 4.27887 0.0816773 0.760548 2.93196 -2.43461 +43 1 0.942186 3.3633 0.783926 -3.69777 5.09684 -0.0674025 +44 1 8.51583 4.33027 0.838505 2.60137 -0.826864 1.21094 +45 1 1.65067 3.4812 8.47243 0.730068 -2.57113 1.91442 +46 1 2.5668 4.2649 8.54781 -0.773361 3.29166 6.51609 +47 1 2.51515 3.35935 0.92744 0.397687 12.5391 -13.0985 +48 1 1.73465 4.30243 0.83421 -1.47193 -2.67124 0.923933 +49 1 3.37869 3.37397 0.0291446 3.12688 15.3224 -6.53558 +50 1 4.34738 4.34434 0.00829503 -5.52046 -6.93359 -2.07611 +51 1 4.32411 3.36572 0.836745 -2.16657 1.87946 3.00206 +52 1 3.33524 4.20214 0.9322 3.17725 3.34929 -6.83564 +53 1 5.08499 3.41929 0.036632 4.03928 -2.58738 -4.81317 +54 1 6.04127 4.33974 8.49644 -0.624803 -0.102814 0.982479 +55 1 6.01611 3.33685 0.909561 -5.08671 5.06768 -6.62403 +56 1 5.207 4.2377 0.760733 -1.32975 0.891019 3.81461 +57 1 6.81304 3.47817 0.0178755 -0.843928 -8.06693 -2.50137 +58 1 7.73203 4.2048 0.00740382 -1.99245 1.66716 -1.57857 +59 1 7.78831 3.44874 0.953497 -3.78613 -1.03229 -4.77194 +60 1 6.90781 4.17709 0.825008 -1.46363 4.64194 5.22986 +61 1 8.46845 5.09622 8.47404 12.6898 1.90364 12.9104 +62 1 0.797366 5.93181 8.52222 2.38416 2.33873 2.4531 +63 1 0.806155 5.19524 0.885366 4.86564 -4.44474 -2.27198 +64 1 0.0123025 5.95271 0.830227 -4.90982 1.72838 0.59014 +65 1 1.70825 5.09756 8.50872 2.27411 3.17124 11.7261 +66 1 2.57892 5.99612 8.47434 -1.64581 0.780097 1.78814 +67 1 2.53606 5.08073 0.912891 1.82428 2.12405 0.338003 +68 1 1.76245 6.06361 0.855052 -0.817516 -1.26047 -0.587481 +69 1 3.36815 5.1611 0.0892763 -1.75416 -1.94918 -4.15038 +70 1 4.34388 5.99478 8.53994 -9.12199 -5.82315 -0.643131 +71 1 4.22842 5.14974 0.779802 4.93843 -0.926739 3.98855 +72 1 3.45177 5.94376 0.905424 -5.40353 3.18508 -3.48186 +73 1 5.06545 5.13306 8.4631 8.02458 6.68819 3.23791 +74 1 5.91929 6.01015 8.53548 3.77131 -1.20656 -2.03594 +75 1 5.88805 5.11842 0.816496 5.73582 1.96394 -4.01157 +76 1 5.18785 6.02276 0.820364 -9.36617 -3.77225 -2.84856 +77 1 6.8933 5.1517 8.49766 -1.10898 -0.445881 0.788116 +78 1 7.73242 5.99103 8.48869 1.48322 -7.68495 9.10162 +79 1 7.66553 5.0457 0.7869 0.413505 3.32493 1.60624 +80 1 6.9298 5.9353 0.896867 -3.44217 0.759559 -1.89572 +81 1 0.0757853 6.76414 0.08264 -2.09776 5.63137 -2.35842 +82 1 0.929754 7.68563 0.0937614 -14.24 2.10473 -10.1605 +83 1 0.947372 6.93568 0.898093 -37.7638 -41.2899 -5.14895 +84 1 0.0463649 7.75037 0.902481 -0.259219 -2.38896 -3.08434 +85 1 1.64115 6.89463 8.52754 6.28385 -7.53573 1.49633 +86 1 2.53763 7.75472 8.45351 15.1175 -6.89071 16.4408 +87 1 2.60347 6.88355 0.853331 -4.53589 -3.86491 -4.69681 +88 1 1.61173 7.63221 0.905993 43.7793 33.7511 -1.13346 +89 1 3.3813 6.82692 8.54355 -0.238432 1.95456 2.34043 +90 1 4.24371 7.77989 0.043504 -5.67067 -7.72392 -1.84442 +91 1 4.1828 6.86814 0.818276 1.21815 -0.827933 0.630987 +92 1 3.3368 7.7382 0.923275 7.52639 -2.01137 -4.72269 +93 1 5.071 6.7563 0.010658 5.49209 11.6713 -3.15323 +94 1 5.90188 7.6356 0.0424163 1.86621 0.862931 -1.97936 +95 1 6.03172 6.8673 0.938495 -1.34369 1.09475 -9.39496 +96 1 5.15248 7.77523 0.857214 -2.90101 -1.73408 2.05686 +97 1 6.89959 6.76423 0.01648 -11.1028 0.34724 0.750719 +98 1 7.65506 7.70409 0.0429309 2.74021 -1.34663 -2.67212 +99 1 7.64597 6.8087 0.792436 6.14337 0.285334 5.54838 +100 1 6.81299 7.61529 0.784654 1.50923 3.73377 2.87701 +101 1 0.039157 8.46192 1.76149 -3.85041 1.88762 -2.12951 +102 1 0.799188 0.819633 1.69376 4.21763 0.723161 -3.63495 +103 1 0.763005 0.0408753 2.55669 11.5628 -1.30287 -1.53659 +104 1 0.0652633 0.934891 2.49039 -5.1145 -1.67274 5.33691 +105 1 1.66381 8.45402 1.66249 1.87623 5.22247 1.17986 +106 1 2.503 0.802578 1.65731 0.0918423 3.77669 3.70231 +107 1 2.51579 0.0135642 2.53917 0.463256 0.0266605 -0.815012 +108 1 1.65685 0.926197 2.57259 5.9178 -9.1905 -0.306187 +109 1 3.4242 0.0443963 1.67808 1.33331 -0.794171 2.32841 +110 1 4.23298 0.877511 1.6619 2.15651 0.36791 0.599305 +111 1 4.23114 8.48221 2.59613 0.139704 5.19667 3.26797 +112 1 3.42382 0.825355 2.52764 0.831325 -0.597344 0.750298 +113 1 5.10755 0.098598 1.64667 1.13835 -0.15217 0.418453 +114 1 6.07979 0.861483 1.66377 -9.38879 -3.1028 5.61252 +115 1 6.06362 0.0403691 2.64895 -6.98521 -8.98289 -11.9164 +116 1 5.20913 0.939312 2.59362 -1.28414 -1.16831 -2.67638 +117 1 6.75529 8.52816 1.79359 4.36806 -0.709446 -4.01445 +118 1 7.76101 0.764033 1.62558 -1.73868 3.93794 4.49945 +119 1 7.66206 0.0708021 2.53607 1.47505 -2.32899 1.29594 +120 1 6.92286 0.947435 2.52138 -4.88314 -16.5943 7.22153 +121 1 8.51449 1.72985 1.71942 6.76951 -3.05423 -0.995536 +122 1 0.834691 2.62553 1.61171 16.0236 -0.437826 23.4167 +123 1 0.945534 1.71145 2.53519 -17.6422 5.766 10.6769 +124 1 8.53575 2.60321 2.48391 2.61084 -9.58061 10.2444 +125 1 1.63294 1.72028 1.76938 14.1815 -0.440268 -11.5313 +126 1 2.57682 2.65502 1.67415 2.8611 -15.9615 10.724 +127 1 2.65189 1.65955 2.48962 -4.47742 1.085 2.58429 +128 1 1.79145 2.49644 2.55538 0.0425348 2.96537 1.56716 +129 1 3.45687 1.73281 1.73911 -3.75938 -0.279924 -8.91417 +130 1 4.34908 2.51749 1.7514 -3.12574 5.69408 -7.34516 +131 1 4.21985 1.73239 2.48294 4.56177 -5.44217 8.83153 +132 1 3.39941 2.5984 2.48766 0.0932155 -0.49927 3.02478 +133 1 5.22539 1.80308 1.7328 -5.21779 -2.43895 2.23844 +134 1 6.07426 2.60134 1.71356 -9.82102 -9.11759 6.53349 +135 1 6.06098 1.72463 2.48049 -24.0059 1.32147 25.9525 +136 1 5.04217 2.48583 2.60699 6.13261 3.37855 2.31458 +137 1 6.77443 1.68358 1.80416 26.2694 11.8834 -33.3324 +138 1 7.78345 2.52468 1.65191 -10.0717 7.23238 6.81167 +139 1 7.67217 1.70427 2.51662 7.38759 5.50979 0.483479 +140 1 6.87655 2.54802 2.65887 0.828003 6.30102 -11.6733 +141 1 8.48905 3.38009 1.79052 3.95862 11.358 -4.16794 +142 1 0.904648 4.31805 1.73458 -1.64595 0.0791848 -3.59387 +143 1 0.882159 3.48871 2.5578 -1.47386 -2.40831 0.515883 +144 1 0.0640856 4.36164 2.51005 -1.54232 -2.6948 -1.06039 +145 1 1.78366 3.38548 1.78248 -8.79706 -1.19951 -6.15917 +146 1 2.61647 4.18826 1.75601 -13.6767 13.2656 0.0962066 +147 1 2.49967 3.46972 2.59724 11.287 -7.88562 -0.187146 +148 1 1.72994 4.21494 2.4741 -1.76295 10.5241 6.69302 +149 1 3.35408 3.46945 1.74549 12.0923 -11.3982 2.63093 +150 1 4.33371 4.2573 1.65266 -1.0572 -0.0681575 -0.357999 +151 1 4.25135 3.37501 2.62082 -0.724851 2.23609 -3.08367 +152 1 3.37046 4.34755 2.6064 0.218455 -8.01846 -3.14612 +153 1 5.16664 3.3978 1.80383 -2.26051 -2.46633 -4.30603 +154 1 6.02075 4.21565 1.63908 -0.444656 2.88859 -0.464916 +155 1 6.04443 3.46025 2.46975 -2.50911 -3.21487 7.82311 +156 1 5.06457 4.21348 2.57808 1.01082 5.99339 -2.31274 +157 1 6.80721 3.3694 1.6818 12.0846 7.00158 1.77966 +158 1 7.66426 4.31037 1.75089 1.93845 -1.12426 -1.15071 +159 1 7.67666 3.35746 2.66226 0.0349977 1.35377 -1.51011 +160 1 6.86746 4.18845 2.58559 1.34212 2.76274 1.29577 +161 1 0.0121787 5.21746 1.67805 -1.66136 -3.05338 2.49187 +162 1 0.848043 6.06063 1.634 -1.152 -1.54074 2.03353 +163 1 0.891535 5.1714 2.53903 -1.80088 0.0367987 2.5043 +164 1 8.53141 6.02479 2.48115 1.46529 0.600203 2.28151 +165 1 1.67096 5.18637 1.75513 2.90335 -0.353263 -4.03581 +166 1 2.63344 6.0279 1.70432 -16.3644 -8.57778 -6.55322 +167 1 2.48532 5.10477 2.59913 0.462017 -0.718364 -1.79537 +168 1 1.74617 5.95248 2.59859 0.0442724 3.34654 -0.327538 +169 1 3.3871 5.11741 1.76498 -0.70902 0.100622 -1.55997 +170 1 4.23897 5.91622 1.65627 3.82091 1.24022 3.5679 +171 1 4.18272 5.19526 2.64844 4.07887 -0.154168 -2.99301 +172 1 3.33243 6.04257 2.48749 13.2178 -9.29314 8.76503 +173 1 5.21355 5.13048 1.6694 -5.38913 -0.724028 1.81762 +174 1 5.88731 6.04999 1.61164 27.08 -23.484 7.87668 +175 1 5.91685 5.19555 2.55373 8.22272 -5.32197 -1.91553 +176 1 5.22513 6.01752 2.48789 -6.37641 3.03262 4.81469 +177 1 6.87923 5.14396 1.75241 -1.31228 -0.52571 -0.175031 +178 1 7.66325 6.00346 1.75398 1.55065 0.721262 -1.56625 +179 1 7.71088 5.21107 2.64045 -0.197441 -3.63935 -3.47269 +180 1 6.81367 6.03163 2.50271 -0.887486 -5.65654 8.47366 +181 1 8.45469 6.86312 1.68381 5.32955 -1.93357 -1.0964 +182 1 0.887234 7.64699 1.70441 -8.03342 4.67955 6.65869 +183 1 0.827773 6.84361 2.49826 0.666014 -0.927683 2.41577 +184 1 0.0243326 7.6531 2.64337 -2.41729 -1.59288 -7.26092 +185 1 1.67566 6.82407 1.70759 6.3287 0.149047 4.42322 +186 1 2.51454 7.65687 1.63227 -3.24159 2.2536 7.24906 +187 1 2.61047 6.80534 2.59521 -8.48569 7.62473 -2.75927 +188 1 1.62469 7.75189 2.55083 1.70283 -3.32336 -0.400725 +189 1 3.32845 6.81114 1.68061 10.3844 9.25335 0.5217 +190 1 4.35781 7.7751 1.79868 -7.49989 -3.23754 -13.7369 +191 1 4.19243 6.92819 2.60428 15.2501 -13.591 -1.36339 +192 1 3.43706 7.60555 2.52571 -13.7857 14.6138 -0.968483 +193 1 5.20185 6.77695 1.66316 -21.9331 19.6829 3.32007 +194 1 5.90138 7.62608 1.77842 3.59956 5.50204 -2.20333 +195 1 5.95566 6.93899 2.64467 1.5684 -14.0837 -9.48217 +196 1 5.06902 7.62841 2.55428 6.74225 1.46675 8.63059 +197 1 6.76742 6.8085 1.78801 1.36869 6.36826 -6.59728 +198 1 7.65843 7.62584 1.68675 -2.22178 4.8322 -2.62428 +199 1 7.67415 6.89867 2.52463 2.21143 -5.15334 3.5596 +200 1 6.87662 7.66202 2.55284 -3.26152 2.73313 1.32325 +201 1 0.0405641 8.51038 3.32948 -5.92557 3.54592 8.59039 +202 1 0.809165 0.908392 3.38948 1.71953 -1.70344 0.923667 +203 1 0.901714 8.46653 4.19384 -9.71216 4.93867 8.34322 +204 1 0.069999 0.928448 4.31429 -4.27362 -2.53344 -6.14786 +205 1 1.6264 8.4509 3.42354 8.98155 6.03203 -6.76996 +206 1 2.65602 0.762944 3.43842 -5.54094 5.64927 -11.0802 +207 1 2.61793 0.0468587 4.22961 -1.55064 -6.54911 6.6458 +208 1 1.68094 0.888048 4.32275 0.711784 -4.72688 -3.71581 +209 1 3.43429 8.45723 3.40115 7.64008 12.4108 0.619842 +210 1 4.23416 0.880739 3.42582 5.39503 -6.32873 -0.402512 +211 1 4.18642 8.4609 4.33191 11.6244 16.7018 2.29066 +212 1 3.36155 0.898574 4.22656 4.93072 -1.64922 5.55995 +213 1 5.13206 0.0787666 3.45034 -0.945527 -3.11163 -2.8253 +214 1 6.05542 0.815095 3.33818 0.680768 11.3265 10.7561 +215 1 5.88615 0.068379 4.32153 11.9175 -9.57172 -8.45948 +216 1 5.21525 0.885851 4.19789 -5.15816 5.54694 4.34946 +217 1 6.80589 8.45257 3.40423 5.88256 0.0541198 6.21084 +218 1 7.74454 0.870555 3.46229 0.501904 -4.05279 -5.44709 +219 1 7.62711 0.0144156 4.35804 1.95636 -0.757148 -6.431 +220 1 6.7475 0.756319 4.34542 2.82117 3.60456 -0.442947 +221 1 0.046471 1.74765 3.48426 -2.94726 0.460616 -2.28233 +222 1 0.888532 2.54472 3.37968 0.966992 1.17998 0.546373 +223 1 0.832134 1.79852 4.28422 5.1168 -14.8036 -11.8055 +224 1 0.0855384 2.60849 4.37243 -9.37894 3.13224 -11.0091 +225 1 1.76053 1.64213 3.45381 -3.40447 2.71972 -2.85028 +226 1 2.52635 2.61582 3.43297 3.65437 -1.51294 -3.08517 +227 1 2.50122 1.75788 4.25552 8.72555 -0.689386 -1.86072 +228 1 1.75205 2.6278 4.21833 -8.89154 -5.54607 2.69229 +229 1 3.50205 1.65486 3.36684 -7.50491 6.39615 -0.836562 +230 1 4.28152 2.60594 3.4252 -1.76945 -2.76432 2.53661 +231 1 4.17705 1.67239 4.28707 6.76533 -1.25356 -1.29705 +232 1 3.44438 2.47178 4.25656 -4.81944 5.002 -0.576402 +233 1 5.22486 1.68937 3.43619 -3.28026 2.78772 -4.39101 +234 1 6.02069 2.55292 3.33778 -3.72236 0.507942 3.01424 +235 1 5.96152 1.77008 4.23889 4.98563 -0.248026 3.40967 +236 1 5.17107 2.61009 4.24734 -0.598251 0.473097 -0.376582 +237 1 6.87337 1.72985 3.32607 -2.78397 -6.76638 7.83701 +238 1 7.692 2.50127 3.44714 2.52098 2.71173 -0.194497 +239 1 7.63531 1.64894 4.19535 0.881487 3.19892 6.53537 +240 1 6.92924 2.5559 4.32195 -3.68781 1.74243 -2.92343 +241 1 0.0154582 3.42553 3.38818 0.573657 0.250438 1.11994 +242 1 0.946668 4.34133 3.49534 -14.1263 -16.7645 -9.90419 +243 1 0.911751 3.43019 4.31621 -0.850264 0.755291 -1.68921 +244 1 0.0046042 4.25775 4.34424 -1.31738 -1.24756 -1.54253 +245 1 1.76086 3.48229 3.3966 -12.418 -8.98763 3.21891 +246 1 2.48605 4.22978 3.40508 14.0841 10.3397 -4.15997 +247 1 2.54799 3.33831 4.30225 4.92033 13.8543 -7.00111 +248 1 1.7676 4.3622 4.17566 0.280546 -16.6448 26.3844 +249 1 3.37038 3.45998 3.42173 -0.200746 -1.45028 -1.29578 +250 1 4.20874 4.30541 3.50172 4.65367 -11.48 -19.1828 +251 1 4.21154 3.43635 4.23457 4.19917 -3.40534 2.03948 +252 1 3.45806 4.23712 4.25878 -8.55751 2.75292 6.08306 +253 1 5.11168 3.47839 3.3691 -0.311412 -5.69502 5.70804 +254 1 5.92148 4.26406 3.41002 5.13821 -1.04796 0.0327238 +255 1 6.02264 3.46008 4.23226 -3.02748 -3.55814 1.41554 +256 1 5.17114 4.24863 4.35423 -2.77791 4.93248 -13.0008 +257 1 6.86557 3.34851 3.50434 -4.54964 -0.0741147 -9.06001 +258 1 7.67607 4.29403 3.50495 4.02814 6.65377 -10.7943 +259 1 7.67432 3.49417 4.17544 8.6417 -11.3672 14.2425 +260 1 6.8466 4.22166 4.23144 -3.46256 4.46394 4.938 +261 1 0.0814499 5.05812 3.37338 -2.94602 3.43381 2.0972 +262 1 0.952662 5.9924 3.43554 -2.60446 0.4469 0.54362 +263 1 0.765082 5.07607 4.26673 5.31334 4.0071 5.5605 +264 1 0.0672914 5.95184 4.29838 -1.77164 3.23629 -2.96482 +265 1 1.64676 5.09677 3.49021 9.45599 25.7387 -15.7709 +266 1 2.59524 6.06011 3.441 -1.69946 -11.0916 -4.14222 +267 1 2.46878 5.21999 4.3176 5.41184 -22.6386 -22.4739 +268 1 1.72435 5.99765 4.33067 -8.961 3.18884 -2.81076 +269 1 3.33576 5.13502 3.32819 -1.95672 4.97188 10.3591 +270 1 4.33219 6.01601 3.4905 -3.43576 -1.4684 -1.43775 +271 1 4.2868 5.05318 4.19611 2.54498 12.874 12.0539 +272 1 3.47487 5.92769 4.31716 -1.095 0.823289 -0.856965 +273 1 5.22135 5.10776 3.40172 -8.93936 2.06172 1.30023 +274 1 6.0405 5.92456 3.43523 0.724841 2.24513 0.144002 +275 1 5.92006 5.1314 4.26005 8.25611 -3.42587 -2.20917 +276 1 5.11155 5.91401 4.29084 1.00396 1.28478 -0.181662 +277 1 6.86476 5.07118 3.47111 -5.70253 1.83988 -3.65428 +278 1 7.60709 5.97166 3.43329 1.57958 3.02153 1.22094 +279 1 7.62121 5.17116 4.25108 13.415 -9.76593 -1.32536 +280 1 6.90725 5.93696 4.35438 -12.0061 10.5099 -5.89092 +281 1 0.0158532 6.88433 3.5005 2.50125 -3.66413 -3.15884 +282 1 0.832759 7.6858 3.39159 0.810583 -3.83454 1.16734 +283 1 0.879361 6.87893 4.25184 1.06811 -4.80567 -3.71366 +284 1 8.48025 7.67569 4.32838 6.71448 4.3067 1.89144 +285 1 1.76699 6.83608 3.37875 -3.92913 2.06189 -0.762911 +286 1 2.64337 7.79272 3.38564 -11.5742 -11.6301 0.504133 +287 1 2.51611 6.79594 4.20547 2.9771 6.7763 8.40555 +288 1 1.73472 7.75634 4.30153 3.5376 -4.65751 1.06495 +289 1 3.42458 6.78486 3.36363 0.711862 2.92454 6.30952 +290 1 4.29146 7.78029 3.51531 3.92856 -8.43358 -6.61451 +291 1 4.22796 6.89496 4.356 2.49253 -3.58746 -4.19183 +292 1 3.49073 7.69895 4.31251 -15.4332 -7.21194 0.0843114 +293 1 5.03295 6.88949 3.43613 2.4132 0.715094 1.20127 +294 1 5.9914 7.60738 3.43115 0.166605 10.2994 10.8333 +295 1 6.06057 6.76316 4.28526 -0.682389 0.774521 0.518315 +296 1 5.1506 7.68481 4.35956 -0.587179 -0.831286 -4.17718 +297 1 6.91829 6.87557 3.41173 -2.20287 0.087574 0.74732 +298 1 7.77376 7.66664 3.47631 -5.20912 2.94829 -3.10686 +299 1 7.7733 6.85147 4.2793 -6.28798 -5.26886 2.97867 +300 1 6.79627 7.70864 4.34123 1.13479 0.471756 -2.41754 +301 1 8.47537 0.0666715 5.07785 3.07732 -2.35936 2.36099 +302 1 0.837862 0.824189 5.08442 2.67015 -0.0526079 4.2528 +303 1 0.947354 8.53746 5.97515 -9.44477 -2.06512 3.38353 +304 1 8.45527 0.903487 5.90211 4.35699 -8.49334 13.6006 +305 1 1.71466 0.0614796 5.21675 1.71751 -10.7388 -14.8483 +306 1 2.56545 0.785351 5.1483 1.0332 2.19745 -1.75997 +307 1 2.58448 8.48208 5.91956 0.430753 0.76971 3.58164 +308 1 1.65003 0.816215 5.93197 3.03102 12.7849 8.36083 +309 1 3.46033 0.0141985 5.16494 -4.25366 -0.783326 -0.484155 +310 1 4.20213 0.929517 5.13838 2.42665 -3.78185 -0.152962 +311 1 4.26733 0.0836521 5.92638 3.25998 -1.091 1.74874 +312 1 3.41102 0.861262 6.03148 -0.949591 0.0559607 -1.66554 +313 1 5.1564 8.53616 5.06672 -11.5945 -0.673098 9.37255 +314 1 5.94115 0.761043 5.20173 4.62182 33.122 -29.3364 +315 1 5.93463 0.0696556 5.8868 1.75697 -30.8547 30.3151 +316 1 5.14065 0.9256 5.95741 -0.006185 -4.789 2.4932 +317 1 6.91953 8.50208 5.18386 -10.6338 4.52372 2.129 +318 1 7.72317 0.898909 5.10883 -6.55365 -0.206627 -4.30053 +319 1 7.67728 0.0288812 5.99182 2.50541 0.776267 0.642418 +320 1 6.91834 0.891409 5.91811 -4.13582 -0.84176 -0.41985 +321 1 0.0355634 1.62397 5.15959 0.786537 13.0999 -7.10363 +322 1 0.855042 2.4658 5.05819 10.8208 10.8619 21.426 +323 1 0.798893 1.71459 6.01685 5.79471 -4.43182 -0.915803 +324 1 0.0659206 2.49237 5.91102 -5.57064 6.4328 0.916789 +325 1 1.77633 1.69788 5.04117 -5.55508 3.43302 7.46453 +326 1 2.55086 2.64298 5.08873 0.0193134 -8.77259 6.85672 +327 1 2.49765 1.63315 5.92814 1.12021 1.50275 1.88199 +328 1 1.80539 2.621 5.95731 -6.21714 -3.35524 -0.269961 +329 1 3.34329 1.63256 5.07699 -2.20219 4.06192 2.43743 +330 1 4.31458 2.52073 5.06335 -0.0632538 1.3392 1.20942 +331 1 4.33916 1.68863 5.97126 -3.41941 3.44417 2.01134 +332 1 3.42212 2.64548 5.89276 -0.0280586 -2.67425 3.44656 +333 1 5.16333 1.72803 5.18363 0.62931 0.268233 -3.53629 +334 1 5.97493 2.53755 5.18126 5.42417 -2.99996 -10.5798 +335 1 5.97644 1.77632 6.05208 2.30795 -0.932212 -2.38345 +336 1 5.20771 2.64035 5.9206 -9.19429 -1.91265 5.67918 +337 1 6.82113 1.7288 5.07227 0.319047 -2.27809 2.42075 +338 1 7.76584 2.66005 5.04767 0.36372 -2.98667 3.98468 +339 1 7.68048 1.73285 5.98682 1.83082 2.55026 -3.35109 +340 1 6.77723 2.66049 6.0628 11.9195 -28.0419 -0.192401 +341 1 8.52926 3.48894 5.20725 0.756027 -4.20422 -2.12394 +342 1 0.880496 4.18659 5.21886 -2.21024 5.88812 -5.98946 +343 1 0.823278 3.46696 6.03218 3.03891 -2.5906 1.31712 +344 1 8.45604 4.28238 5.97679 3.43734 -0.298701 2.3281 +345 1 1.66848 3.43018 5.1681 4.45896 -2.65722 -0.776378 +346 1 2.47623 4.29797 5.21376 10.0204 -9.1421 -8.64412 +347 1 2.46945 3.49538 6.0664 15.3766 -12.245 -4.5397 +348 1 1.75883 4.22715 6.00615 -17.7933 12.7993 4.23364 +349 1 3.32535 3.48763 5.18919 1.16348 3.11251 -2.54898 +350 1 4.29953 4.30461 5.21296 -7.48003 6.57243 -13.8987 +351 1 4.32836 3.50006 5.90127 -9.25916 -18.9556 4.88449 +352 1 3.45987 4.23872 6.06433 -4.26661 1.09432 -3.11516 +353 1 5.16317 3.46797 5.05136 -2.20358 -10.3645 8.38524 +354 1 6.01128 4.18674 5.11415 3.72823 2.851 1.21774 +355 1 6.05124 3.32995 5.89897 -17.0823 24.7049 3.10753 +356 1 5.05098 4.23901 5.94533 18.4684 10.5132 6.34816 +357 1 6.93195 3.37363 5.21832 -12.1973 3.61502 -16.8233 +358 1 7.67472 4.24466 5.1448 -0.046387 1.44369 -2.14451 +359 1 7.59877 3.3598 5.99617 16.3705 11.4653 3.48987 +360 1 6.9163 4.33093 6.01136 -0.884888 -0.827495 0.436994 +361 1 8.47485 5.1618 5.06757 4.58611 -6.95556 3.64111 +362 1 0.866551 5.92561 5.22826 -2.4458 0.731452 -4.83922 +363 1 0.856029 5.03088 5.93872 -0.961264 1.16585 2.50638 +364 1 0.025531 6.08363 6.03301 -0.603503 -3.86392 0.433571 +365 1 1.73882 5.05771 5.16436 -7.87894 6.49017 -0.085231 +366 1 2.54586 5.89415 5.04217 4.79689 21.4637 24.3945 +367 1 2.63875 5.11717 5.9033 -10.4096 0.222879 12.4433 +368 1 1.7282 6.02787 5.89482 3.82714 -3.17245 6.07309 +369 1 3.41343 5.11888 5.19776 7.89672 -3.25441 -9.4893 +370 1 4.34849 6.08405 5.13729 -6.43313 -7.37614 1.57014 +371 1 4.30919 5.18003 6.06007 -0.523489 -1.53897 -0.492658 +372 1 3.32135 5.97978 5.88753 6.80953 0.93257 3.29984 +373 1 5.2281 5.04347 5.09516 -5.81719 1.07839 6.76004 +374 1 5.94602 5.8851 5.09539 3.02249 4.44225 2.10278 +375 1 6.04092 5.17575 6.07061 0.50428 -9.39491 -12.3653 +376 1 5.21437 6.06631 6.06016 -6.35945 -8.11006 -13.4627 +377 1 6.91579 5.12007 5.08308 -5.11836 -4.49572 6.409 +378 1 7.70983 5.91053 5.07808 1.5309 9.32926 6.58643 +379 1 7.76683 5.15653 6.01534 -1.66429 -5.18049 -8.59085 +380 1 6.93784 6.03915 5.96221 -25.2768 -19.3137 -6.75792 +381 1 0.0625638 6.74931 5.10819 -0.676634 2.54846 -0.0250987 +382 1 0.86361 7.61298 5.03345 -2.5044 7.0388 6.38474 +383 1 0.851706 6.88156 6.03092 0.201379 -3.97494 -1.33706 +384 1 0.0506067 7.6425 5.89338 -1.769 2.22377 0.622415 +385 1 1.66322 6.86583 5.19561 3.09287 -3.33398 -7.05581 +386 1 2.62799 7.62451 5.17609 -27.9662 28.0267 -4.59006 +387 1 2.66202 6.83135 5.96842 -24.8289 -0.817724 19.495 +388 1 1.64735 7.66733 5.92394 4.49398 5.54382 1.70924 +389 1 3.32274 6.93842 5.22499 45.6897 -26.2601 -20.0997 +390 1 4.28266 7.68312 5.1494 -0.162983 0.307259 3.3477 +391 1 4.21122 6.74188 6.04596 -0.795282 5.66715 -3.63702 +392 1 3.40786 7.67271 6.05784 2.18013 1.35082 -0.335047 +393 1 5.13386 6.80127 5.05013 6.80473 4.27889 3.23937 +394 1 6.0188 7.62146 5.18796 -3.27693 10.2601 -11.1928 +395 1 5.9142 6.93974 5.96821 7.16288 -22.7812 5.828 +396 1 5.1207 7.60724 5.96887 -13.0365 8.36981 -2.80723 +397 1 6.90344 6.91817 5.14994 -0.204819 -5.34708 -0.858742 +398 1 7.6747 7.73724 5.15589 4.74286 -4.17129 0.509029 +399 1 7.64232 6.7419 6.03772 18.4896 23.5989 -0.89996 +400 1 6.75496 7.62762 6.01659 7.03025 5.11039 1.24431 +401 1 0.0963896 0.0201086 6.80553 -1.40648 -0.449972 0.0493894 +402 1 0.835843 0.891839 6.79877 7.20248 -7.32555 0.745706 +403 1 0.918901 8.53581 7.64787 -17.0565 2.54879 17.4592 +404 1 0.0577403 0.896342 7.73471 1.30728 -4.31515 -1.61795 +405 1 1.61051 8.45024 6.92242 29.7484 14.9171 -14.6755 +406 1 2.47578 0.885204 6.88627 1.39053 -1.86497 -2.40181 +407 1 2.50444 0.0274811 7.76899 5.04636 2.83552 -7.66004 +408 1 1.76075 0.832954 7.77629 -9.26653 -0.311946 -7.26081 +409 1 3.50837 8.51457 6.78791 -7.98313 -6.7176 0.868776 +410 1 4.17648 0.757665 6.93195 8.57719 11.9693 -2.56623 +411 1 4.23832 0.0657272 7.77237 -2.00114 -7.83956 -8.62893 +412 1 3.37339 0.86481 7.76894 -4.57993 4.49098 -10.8865 +413 1 5.14407 0.0592801 6.76072 -1.57797 -1.16589 1.03837 +414 1 5.93853 0.879814 6.88423 6.63031 -4.29327 -1.40131 +415 1 6.03919 8.48714 7.63222 -2.96915 1.1039 1.2166 +416 1 5.15255 0.794385 7.73799 -0.425319 2.1861 -1.28188 +417 1 6.89313 0.0918814 6.89086 -1.49841 -3.77335 -3.98868 +418 1 7.61212 0.939213 6.80354 8.77263 -4.1407 2.30253 +419 1 7.70899 8.53849 7.72172 -1.01623 -1.03696 -1.75272 +420 1 6.83169 0.853131 7.69229 0.514071 1.96118 2.47006 +421 1 0.0995377 1.63996 6.92907 -20.9698 6.48021 -16.3567 +422 1 0.856061 2.59196 6.8009 3.6314 -4.45866 -1.95318 +423 1 0.7986 1.79168 7.64825 21.262 -5.45904 12.6361 +424 1 0.086833 2.5674 7.63497 -11.6486 2.30739 1.5806 +425 1 1.65946 1.72494 6.90853 -2.96091 -3.71884 -7.8878 +426 1 2.55175 2.62076 6.77199 1.34599 -1.3093 4.14575 +427 1 2.49264 1.73911 7.61263 5.68035 -0.198489 5.50404 +428 1 1.73023 2.55227 7.60126 -2.61513 6.16936 5.4644 +429 1 3.34887 1.7831 6.78557 0.7181 -0.718938 0.35045 +430 1 4.23104 2.60662 6.78869 6.67274 -5.2978 -0.800832 +431 1 4.35855 1.74494 7.60411 -4.34125 -3.35913 2.62052 +432 1 3.36542 2.60589 7.78048 1.27821 -1.57097 -4.57229 +433 1 5.20004 1.65594 6.83168 -6.03666 5.50106 2.07188 +434 1 5.95504 2.56783 6.93549 0.704503 2.20695 -11.5481 +435 1 6.05448 1.73837 7.6627 -1.83376 -2.83098 2.15288 +436 1 5.1146 2.5438 7.6124 2.3372 -0.290906 4.36925 +437 1 6.88113 1.721 6.77631 -7.16431 5.43568 2.84999 +438 1 7.667 2.62761 6.74793 2.83097 -7.51196 9.4855 +439 1 7.73348 1.72515 7.754 -4.1563 0.657477 -6.03723 +440 1 6.7624 2.63316 7.64937 6.65302 -0.565372 4.94425 +441 1 0.0849859 3.37793 6.84942 -10.0386 4.11872 -3.53604 +442 1 0.857904 4.2895 6.93068 1.24699 0.504054 -2.41984 +443 1 0.822866 3.35005 7.62376 7.62204 5.76535 8.89189 +444 1 0.0609986 4.27823 7.72873 -1.62474 0.278416 -2.41968 +445 1 1.65771 3.45598 6.89789 2.67743 0.0202624 -2.34558 +446 1 2.54508 4.23374 6.86348 0.989961 3.94158 3.39783 +447 1 2.51344 3.50821 7.77131 2.79285 -8.19104 -6.06353 +448 1 1.76675 4.31871 7.74484 -7.62178 -3.47349 -5.94274 +449 1 3.46999 3.3444 6.87805 -6.49672 7.19856 -0.129806 +450 1 4.27761 4.20284 6.7963 2.00695 2.57497 4.55692 +451 1 4.36643 3.33193 7.71738 -5.18938 3.59254 -0.980407 +452 1 3.39117 4.21736 7.78484 2.56803 1.85612 -2.81745 +453 1 5.17851 3.50703 6.80054 -0.562057 -4.69817 1.35476 +454 1 5.91855 4.34694 6.82856 20.1656 -16.4219 -1.68121 +455 1 5.94421 3.41917 7.73472 -0.686701 1.44481 -0.413888 +456 1 5.21752 4.35256 7.70192 -2.57704 -7.73472 4.05334 +457 1 6.81349 3.41173 6.82265 -1.40277 6.3135 5.01717 +458 1 7.75813 4.35693 6.90395 -1.64702 -1.61669 -0.476323 +459 1 7.7614 3.35066 7.72289 -1.59004 1.58238 -2.0122 +460 1 6.90386 4.19648 7.73719 0.143217 3.47184 -3.3084 +461 1 8.51568 5.21538 6.91302 4.27065 -2.85002 -1.50895 +462 1 0.951652 6.01174 6.9207 -11.7991 -7.13131 -18.8927 +463 1 0.936182 5.16144 7.77632 -7.30596 -5.41004 -9.74737 +464 1 0.00163562 6.07485 7.63199 0.624183 -4.07361 5.99132 +465 1 1.66533 5.15284 6.74597 2.96466 -1.56742 2.06772 +466 1 2.61909 5.93515 6.89385 -1.40662 1.18192 -1.24787 +467 1 2.46927 5.13962 7.72554 6.76967 2.2802 -3.81441 +468 1 1.64453 6.02831 7.68681 19.7677 -7.24739 11.5441 +469 1 3.40343 5.06011 6.8889 -0.198511 0.401262 -0.796323 +470 1 4.30752 6.01937 6.85588 -10.789 -11.9311 3.49788 +471 1 4.28416 5.14222 7.62835 0.609452 -0.263512 0.8346 +472 1 3.47645 6.07368 7.70428 -7.22384 -10.7657 -0.906726 +473 1 5.22078 5.0656 6.90915 -18.0053 20.6161 -6.39 +474 1 5.99499 5.93089 6.77083 3.48021 13.0571 15.6598 +475 1 6.05342 5.21794 7.69617 -5.52282 -4.0969 2.40523 +476 1 5.15908 5.93838 7.59985 0.288818 1.34614 5.01043 +477 1 6.82844 5.21514 6.92244 2.6589 -10.3439 -6.80084 +478 1 7.65444 5.90306 6.73997 5.39846 9.09532 17.1635 +479 1 7.73871 5.1328 7.74827 -11.0217 0.411956 -11.9718 +480 1 6.85057 5.9849 7.66627 -2.19779 2.18231 4.19621 +481 1 8.49223 6.85953 6.88515 0.63092 3.61848 -3.8326 +482 1 0.912061 7.72558 6.80554 -14.7372 -15.0451 -0.530208 +483 1 0.94972 6.80465 7.60047 -8.86666 17.9559 7.11774 +484 1 0.0485157 7.69847 7.76952 0.871021 -3.29928 -3.01128 +485 1 1.7395 6.92207 6.74618 -0.216972 -4.99493 2.92958 +486 1 2.48517 7.73307 6.85664 4.02861 0.442708 -0.186237 +487 1 2.60224 6.86957 7.70226 -2.68029 -0.280597 -1.3011 +488 1 1.75659 7.71058 7.78997 -12.217 -12.015 -24.8657 +489 1 3.36601 6.81921 6.83807 2.83617 1.11452 1.50668 +490 1 4.30578 7.6333 6.9198 -11.3388 0.787746 -11.6868 +491 1 4.17656 6.84912 7.75346 9.62737 7.65922 -1.79281 +492 1 3.37828 7.72239 7.62462 0.544776 0.263736 1.68806 +493 1 5.03666 6.75188 6.83201 10.5371 18.8221 7.02157 +494 1 5.88561 7.69892 6.74579 2.44744 2.75196 7.83 +495 1 6.02886 6.89217 7.71335 -1.94107 -2.07696 0.28038 +496 1 5.05253 7.6432 7.63466 10.7152 0.484071 10.517 +497 1 6.76592 6.82276 6.85512 1.71624 -1.12004 -2.46021 +498 1 7.63682 7.73046 6.77254 1.37903 -1.27982 -0.239663 +499 1 7.60482 6.74157 7.76697 8.04118 12.5638 -12.9988 +500 1 6.86424 7.69163 7.60229 0.0588858 0.119654 2.66424 +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +500 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 8.2207069144348992e+00 +0.0000000000000000e+00 8.2207069144348992e+00 +0.0000000000000000e+00 8.2207069144348992e+00 +ITEM: ATOMS id type x y z f_1[1] f_1[2] f_1[3] +1 1 0.0109462 8.19276 8.15872 -2.39444 9.6729 7.55614 +2 1 0.913757 0.79291 0.0997863 -14.8553 6.06953 -19.2131 +3 1 0.922041 0.00329478 0.797424 -4.57303 -13.0314 3.29774 +4 1 0.0667547 0.768895 0.898382 -4.60646 8.57627 -8.38591 +5 1 1.74036 8.13245 0.0766359 -17.8989 17.5469 -5.09772 +6 1 2.47269 0.889925 0.0248853 -5.42566 -21.0007 -17.6291 +7 1 2.46322 8.1233 0.872599 4.75898 11.1097 -4.77186 +8 1 1.65846 0.837491 0.791152 15.1363 -5.40511 14.9864 +9 1 3.32881 8.19546 0.053156 -13.3342 -9.93994 -9.94684 +10 1 4.03279 0.760382 0.00184897 9.91793 7.67217 -5.53917 +11 1 4.13378 8.169 0.732239 -0.574085 -2.22965 11.4349 +12 1 3.20922 0.774467 0.746193 11.6707 -5.4973 20.7036 +13 1 4.84922 8.194 8.14339 7.30804 6.79019 8.16024 +14 1 5.8218 0.772541 8.17358 -10.0231 -1.2549 7.34514 +15 1 5.68256 8.16785 0.77714 3.02512 1.45358 -0.272422 +16 1 4.85759 0.84201 0.746179 4.61671 -0.701957 -1.77598 +17 1 6.62546 8.16087 8.21828 -7.1959 6.90651 13.7327 +18 1 7.47259 0.88807 0.0569708 -4.40901 -2.93179 -3.05075 +19 1 7.47431 0.0411346 0.771198 -11.1102 -3.58532 -4.76152 +20 1 6.57656 0.847149 0.913044 26.339 -17.4997 -36.7448 +21 1 8.18759 1.70398 8.18761 4.1072 -0.492398 0.811998 +22 1 0.899666 2.41042 8.17073 -11.5274 -4.75425 3.68191 +23 1 0.850302 1.72005 0.839978 5.34352 -14.6759 -1.78579 +24 1 0.0603398 2.39798 0.844681 -8.60658 17.5352 -6.64359 +25 1 1.71223 1.59237 0.0242378 -11.0164 14.7761 -6.28233 +26 1 2.39934 2.5183 0.00540478 8.02997 -3.83137 6.03634 +27 1 2.48112 1.56604 0.834626 2.61805 16.1266 0.364368 +28 1 1.6143 2.50502 0.831093 22.9512 -23.9291 -18.4162 +29 1 3.30714 1.5456 0.0352888 3.02185 20.9324 -4.02492 +30 1 4.17998 2.44319 8.21567 -15.5858 -1.30182 -5.2994 +31 1 4.13571 1.72982 0.900024 -11.4398 -17.9409 -9.12775 +32 1 3.31093 2.54257 0.820203 -10.3368 -11.5392 -3.6507 +33 1 5.0044 1.71067 8.16991 -2.52586 -20.2729 12.2321 +34 1 5.83707 2.42978 0.0552544 -9.07217 4.33101 -1.43054 +35 1 5.68958 1.61323 0.87339 20.6627 3.79367 -24.2404 +36 1 4.88712 2.41203 0.783075 18.227 14.4306 8.63131 +37 1 6.51234 1.55641 0.0925838 9.00513 9.77167 -3.15357 +38 1 7.38894 2.55021 8.21638 -3.89162 -5.39246 1.97695 +39 1 7.3932 1.68143 0.910549 14.6159 -16.4356 -32.9418 +40 1 6.52029 2.5195 0.875176 1.21021 -6.27577 -1.18313 +41 1 0.0178952 3.25358 8.17469 3.31384 23.2108 27.1434 +42 1 0.75874 4.10726 8.14569 6.02202 2.9315 8.91628 +43 1 0.895393 3.22207 0.752637 -27.1078 14.1691 0.641871 +44 1 8.18599 4.06691 0.900855 -0.259841 0.495686 -5.35481 +45 1 1.55285 3.22874 8.15747 6.98433 26.3863 8.64396 +46 1 2.49624 4.20319 8.19485 -11.6121 -5.75058 -7.87094 +47 1 2.42547 3.30302 0.888339 10.6882 -12.4594 -2.99107 +48 1 1.6862 4.0108 0.835279 -13.347 15.0654 -7.27246 +49 1 3.22 3.33904 0.0153378 4.70565 -17.4148 -11.2872 +50 1 4.15099 4.01359 0.0472035 -3.25232 -0.128895 -8.82814 +51 1 4.06799 3.24916 0.843927 9.3476 8.05351 2.04714 +52 1 3.19501 4.05 0.736238 12.2088 14.8797 22.981 +53 1 4.93359 3.21205 8.21538 5.02686 8.32666 2.39487 +54 1 5.81852 4.10681 0.0313505 -9.96067 16.6194 -8.35941 +55 1 5.78406 3.36669 0.776887 -2.74739 -9.47942 10.9149 +56 1 4.90983 4.0411 0.864362 0.837356 4.14382 -0.368312 +57 1 6.53897 3.36302 8.19911 9.90234 -20.173 11.5285 +58 1 7.46276 4.04697 0.0534703 -5.76424 1.73449 -3.50806 +59 1 7.34501 3.24442 0.827453 2.34892 5.8087 4.09531 +60 1 6.59021 4.15121 0.905225 -2.44603 -12.1461 -5.89568 +61 1 8.13258 4.93013 0.0905402 6.61239 1.0085 -5.83678 +62 1 0.918786 5.84938 8.18896 -100.34 -125.435 4.75603 +63 1 0.733666 4.90689 0.894865 5.0782 -1.1493 -19.9038 +64 1 8.13743 5.78012 0.885656 21.4143 -27.2006 -30.8387 +65 1 1.67225 4.91657 0.0765019 -6.36422 -5.41993 -9.68754 +66 1 2.43163 5.74665 8.16344 0.0454169 7.36314 0.282499 +67 1 2.52248 4.94902 0.779546 -17.0632 -3.92502 5.40756 +68 1 1.68817 5.73221 0.738326 -10.7061 -22.6586 25.0306 +69 1 3.20519 4.98792 8.20267 13.0471 -20.6699 18.764 +70 1 4.1645 5.8475 0.0144516 -41.0284 -51.2746 -22.2701 +71 1 4.12065 4.85332 0.726813 -6.7392 5.54296 9.04283 +72 1 3.22358 5.72978 0.902951 13.2902 6.38408 -11.6219 +73 1 4.86923 4.9681 8.18768 10.2044 -1.77915 -2.81852 +74 1 5.77301 5.70687 8.13281 -22.5863 16.9623 33.7246 +75 1 5.78731 4.97674 0.770243 -6.25016 -2.29075 -2.78772 +76 1 4.89256 5.78932 0.733037 29.9716 -43.8231 39.093 +77 1 6.61696 5.02048 8.19969 -11.3595 -28.891 -1.36328 +78 1 7.33645 5.74186 0.0277988 27.1444 12.1113 -11.7126 +79 1 7.32557 4.92161 0.798933 6.38759 1.63603 8.88722 +80 1 6.60198 5.76847 0.724174 -12.087 6.06842 22.1567 +81 1 0.0632305 6.4911 0.00261304 -6.53376 9.85675 7.22968 +82 1 0.730752 7.3973 8.19101 19.8665 -4.89129 14.6872 +83 1 0.894205 6.53954 0.906348 -15.672 -5.70878 -18.8817 +84 1 0.0916376 7.35116 0.914882 -39.3163 -12.8553 -54.9509 +85 1 1.54844 6.4779 0.0899714 109.204 121.919 -0.90408 +86 1 2.45374 7.43343 8.1677 17.1682 -16.9212 2.53497 +87 1 2.38485 6.48495 0.871503 16.8711 24.0952 -19.5071 +88 1 1.73482 7.30198 0.918245 -4.50526 25.4363 -21.6583 +89 1 3.35837 6.52948 0.00621289 -17.9347 4.05163 8.57797 +90 1 4.15544 7.30314 8.17418 -3.86421 14.3399 10.028 +91 1 4.18078 6.49797 0.807337 -33.0181 25.5019 29.3461 +92 1 3.28881 7.33369 0.840128 0.0678552 -0.60668 -1.16807 +93 1 4.86711 6.50097 0.0644243 55.2704 56.5162 -42.5456 +94 1 5.6807 7.37537 8.15497 2.37339 1.6253 6.06405 +95 1 5.83906 6.54647 0.813774 -8.31017 -0.439493 -0.862375 +96 1 4.90102 7.33548 0.785855 3.38301 3.17369 4.3776 +97 1 6.62594 6.60016 8.16507 -28.5529 -10.5165 29.461 +98 1 7.41236 7.32596 8.18119 12.8158 16.6867 22.5272 +99 1 7.48788 6.57526 0.906715 -17.6408 15.7915 -12.9219 +100 1 6.60846 7.32088 0.891813 -2.23221 1.45701 -6.99196 +101 1 8.17 8.13088 1.54543 21.7946 28.0076 23.7334 +102 1 0.889634 0.755106 1.5647 -2.22366 9.82139 12.4406 +103 1 0.787312 0.00367743 2.47285 9.7959 7.14049 -7.07183 +104 1 0.0399172 0.910289 2.54829 -10.4426 -54.7685 -48.8923 +105 1 1.70161 0.076186 1.70291 0.655659 -5.9987 -1.53887 +106 1 2.5425 0.840944 1.65312 -5.39214 -2.71573 1.42057 +107 1 2.39333 0.0846015 2.56412 19.1459 -13.6703 -26.8796 +108 1 1.62991 0.895915 2.55976 -9.37186 -8.23605 -42.2796 +109 1 3.3255 0.037006 1.60354 -4.30714 4.73223 -3.06839 +110 1 4.20236 0.841896 1.65063 -10.9567 4.39501 -2.76043 +111 1 4.12511 8.16508 2.38147 6.48597 31.2032 29.2026 +112 1 3.37125 0.822661 2.38548 -3.89508 0.169143 6.57094 +113 1 4.86677 0.028066 1.55007 9.3902 -7.55136 2.71818 +114 1 5.8528 0.805894 1.56988 -29.5994 -6.3857 29.2326 +115 1 5.73944 8.2048 2.38025 -0.334985 15.3443 16.2286 +116 1 4.92058 0.739392 2.48512 1.8123 5.57771 -0.399822 +117 1 6.61747 8.14877 1.63757 -7.92973 14.3058 -0.0863647 +118 1 7.37923 0.805843 1.70616 17.0436 -4.06349 -13.2175 +119 1 7.38533 8.17909 2.55221 2.10247 4.05286 -21.3656 +120 1 6.66981 0.91359 2.42776 -18.0385 -1.7859 9.16667 +121 1 8.21433 1.71804 1.64878 9.58557 -8.70073 -6.06848 +122 1 0.91795 2.50647 1.62107 -49.2165 -42.2319 12.3144 +123 1 0.778719 1.62612 2.3667 15.8366 8.16624 0.723179 +124 1 0.0388825 2.56454 2.43408 -0.65123 -11.9302 4.78295 +125 1 1.70614 1.64161 1.56714 -4.83448 1.54656 8.88708 +126 1 2.55772 2.51525 1.68348 -33.0305 -26.0768 -4.05159 +127 1 2.46774 1.68666 2.4295 -0.728639 -2.90689 1.14987 +128 1 1.58495 2.48207 2.53043 32.1395 -14.2129 -42.8967 +129 1 3.28639 1.69638 1.58862 0.141668 -5.07807 4.69228 +130 1 4.07581 2.46356 1.66204 5.75617 5.24573 6.028 +131 1 4.09064 1.65395 2.45941 5.06207 -1.15698 -3.64398 +132 1 3.2978 2.42597 2.51229 -0.392826 8.06961 -8.70923 +133 1 4.99952 1.60143 1.58928 -25.5713 -7.8385 22.8567 +134 1 5.66634 2.3835 1.71386 21.3679 17.6667 -19.1597 +135 1 5.74656 1.70527 2.50917 3.11288 -14.4009 7.07914 +136 1 4.97163 2.46224 2.45828 -14.3686 2.77193 11.4917 +137 1 6.62989 1.62285 1.56611 -20.0211 14.8617 27.1541 +138 1 7.37036 2.42163 1.58976 1.23932 26.194 15.084 +139 1 7.49234 1.71782 2.38524 -11.5645 -3.14792 16.0927 +140 1 6.57493 2.44646 2.50738 3.76278 -0.484364 -1.65815 +141 1 8.13855 3.28395 1.66364 9.95915 -4.6352 -13.1677 +142 1 0.822632 4.13968 1.61013 -1.66869 -18.1546 6.90643 +143 1 0.836195 3.27368 2.50106 -4.0013 3.27813 -2.23185 +144 1 0.00706469 4.04664 2.42415 6.78153 4.66429 11.0832 +145 1 1.56864 3.19926 1.57501 43.2252 54.2341 22.2486 +146 1 2.37435 4.19613 1.65007 19.5365 -23.6872 -5.11708 +147 1 2.53204 3.33272 2.45976 -10.1616 -1.37273 8.96239 +148 1 1.5958 4.02298 2.45513 4.44558 4.83545 -0.957126 +149 1 3.24862 3.20562 1.71329 33.7169 30.1535 -8.86948 +150 1 4.04966 4.11271 1.69147 14.455 0.133261 -16.0308 +151 1 4.17313 3.29199 2.42566 -5.80506 -5.3643 5.35172 +152 1 3.37886 4.04594 2.4591 -12.864 4.86539 14.8631 +153 1 5.00029 3.3715 1.7428 -16.124 -51.6521 -51.6846 +154 1 5.71525 4.10565 1.71106 18.126 11.5713 -25.6554 +155 1 5.67368 3.37853 2.52254 40.5036 -38.7002 16.4445 +156 1 4.98188 4.047 2.42098 -44.4942 70.6847 47.3189 +157 1 6.52567 3.216 1.71371 -0.385424 4.96723 -0.762826 +158 1 7.40007 4.08176 1.73877 -6.32286 -1.56827 -20.7524 +159 1 7.42837 3.30042 2.4503 -10.1629 -6.83382 9.16894 +160 1 6.52178 4.09551 2.40152 8.21405 -5.0269 3.15343 +161 1 0.00699263 4.85762 1.69229 -17.0824 5.05692 -6.94595 +162 1 0.756152 5.6631 1.60232 14.3979 15.6472 -4.59775 +163 1 0.764682 4.99903 2.39299 18.2885 -21.5851 21.4239 +164 1 0.0800264 5.75765 2.41619 -22.1201 11.2764 3.26076 +165 1 1.60226 4.84293 1.69094 -9.96687 23.2298 -5.36928 +166 1 2.38001 5.77059 1.56073 -4.13582 -26.0328 27.2432 +167 1 2.39304 4.87599 2.45449 3.86796 9.40324 7.0282 +168 1 1.5595 5.8443 2.45554 15.3251 -19.3503 -10.1983 +169 1 3.24805 4.8639 1.55208 5.72697 0.833939 9.91621 +170 1 4.12523 5.83768 1.72183 2.66681 -7.18069 -9.93584 +171 1 4.14719 4.98927 2.48442 -5.36599 -4.29088 6.08995 +172 1 3.29103 5.75037 2.41213 -9.14312 -21.8308 11.1485 +173 1 4.88531 4.96658 1.71552 5.62499 -3.03462 -8.19539 +174 1 5.80164 5.66001 1.66617 -22.0309 23.7646 0.752493 +175 1 5.79599 4.88622 2.4436 -18.3543 9.31939 -6.6266 +176 1 4.94007 5.78406 2.4889 7.47518 -6.1933 -6.95152 +177 1 6.50282 4.96059 1.57437 23.9581 -12.4339 8.07292 +178 1 7.43162 5.77666 1.60532 -16.9632 -9.02864 21.2089 +179 1 7.30902 4.88901 2.38072 1.39073 12.4251 10.603 +180 1 6.52191 5.81931 2.5443 7.19321 -57.902 -45.2674 +181 1 0.0825324 6.49799 1.58172 -0.0568703 17.3702 26.5223 +182 1 0.807327 7.40344 1.54436 38.413 9.53604 44.8678 +183 1 0.85313 6.5885 2.46372 -17.206 13.7674 -10.0743 +184 1 0.0766958 7.42441 2.49843 -14.0409 -5.69227 -10.6889 +185 1 1.56626 6.64679 1.65111 17.2201 -21.881 29.7832 +186 1 2.51758 7.48828 1.7101 -1.12703 -9.37355 7.34939 +187 1 2.48642 6.48139 2.37761 -17.45 9.10758 18.4987 +188 1 1.62607 7.39059 2.4668 5.47881 2.11068 -4.08662 +189 1 3.22096 6.48273 1.68127 15.0894 18.1205 -19.6751 +190 1 4.01435 7.47003 1.70259 9.92584 -36.0532 -31.9009 +191 1 4.01053 6.48307 2.56537 4.58494 43.5966 -38.8488 +192 1 3.31708 7.46346 2.49246 -11.1632 -6.704 4.9273 +193 1 4.97912 6.56412 1.70872 -0.0323444 1.40088 -5.51009 +194 1 5.76314 7.42951 1.73429 -4.71194 -18.4847 -18.3917 +195 1 5.75053 6.57569 2.52583 -15.5416 2.95473 -19.9489 +196 1 4.86788 7.33538 2.51839 21.348 1.25465 -21.9702 +197 1 6.54919 6.48383 1.72129 1.36669 8.74928 -8.3147 +198 1 7.40692 7.48075 1.59274 -4.17636 -24.5364 8.08039 +199 1 7.31105 6.49008 2.55841 18.9084 8.98379 -5.81349 +200 1 6.56124 7.4093 2.46898 3.88266 -3.866 3.64736 +201 1 0.0467578 0.0587236 3.25639 -2.58837 -3.06001 8.14477 +202 1 0.919472 0.840587 3.2901 -13.7955 -3.94396 11.0802 +203 1 0.913851 8.17129 4.10222 -17.0314 2.36091 -15.061 +204 1 8.12452 0.831674 4.11824 2.96137 1.66258 0.705395 +205 1 1.72266 8.12268 3.2983 -16.5809 -0.000561518 15.0322 +206 1 2.36681 0.848699 3.23189 33.3023 -3.20785 26.2082 +207 1 2.52451 0.093755 4.0501 -20.4816 -4.23237 16.7496 +208 1 1.57332 0.89934 4.17862 1.65408 -10.4059 -4.79402 +209 1 3.23411 8.18086 3.33998 20.9401 7.85353 -15.8307 +210 1 4.12777 0.912462 3.28751 -3.54395 -8.15241 -0.704223 +211 1 4.05479 8.16789 4.17086 6.43266 7.42359 -18.6916 +212 1 3.3412 0.763098 4.14988 -8.17365 16.5822 -19.2151 +213 1 4.85923 8.19378 3.30398 3.75427 6.29815 -1.39384 +214 1 5.723 0.836221 3.31262 4.07436 -7.7371 -12.3645 +215 1 5.78765 0.0695661 4.10746 2.41957 -4.40965 -1.14115 +216 1 4.97909 0.892899 4.12401 -13.5931 -16.8127 1.66952 +217 1 6.57108 0.0657357 3.30807 -10.4223 -10.045 -0.47006 +218 1 7.35373 0.738008 3.24493 15.9915 16.7978 9.43624 +219 1 7.34677 0.0332152 4.15763 12.3358 5.5849 -5.20193 +220 1 6.67147 0.918341 4.12524 -9.23951 -11.4667 0.577623 +221 1 0.0788919 1.58016 3.21314 -1.55258 49.5779 50.5391 +222 1 0.904188 2.40885 3.22233 -31.0956 -2.82504 30.7646 +223 1 0.877149 1.74225 4.15165 7.55452 -10.7555 -4.03202 +224 1 0.0936835 2.40444 4.16194 -19.0736 7.56858 -3.47745 +225 1 1.71236 1.61805 3.29179 -19.7602 28.7111 2.45155 +226 1 2.5486 2.41776 3.31547 -43.6679 25.9149 -16.2942 +227 1 2.39734 1.55251 4.06577 15.8032 7.53109 12.4652 +228 1 1.72237 2.5181 4.15876 -10.7679 -10.2774 -3.05137 +229 1 3.23039 1.71099 3.29502 25.8646 -44.0791 -9.55739 +230 1 4.12827 2.45813 3.1934 -6.48806 -10.3202 8.62038 +231 1 4.19407 1.63495 4.09603 -15.4993 6.39445 10.1662 +232 1 3.20761 2.36838 4.07177 19.5744 11.0493 29.9438 +233 1 4.94979 1.63514 3.37535 1.21152 5.67416 -27.5114 +234 1 5.82776 2.47766 3.34313 -3.66364 1.42568 -1.20833 +235 1 5.76542 1.58538 4.03513 14.4098 19.4192 12.2978 +236 1 4.95489 2.43394 4.07273 -1.13246 5.06376 7.36624 +237 1 6.661 1.60077 3.30919 -3.43354 8.94885 -5.94598 +238 1 7.49515 2.56092 3.28033 -10.5336 -12.2625 1.51454 +239 1 7.39275 1.71767 4.16117 3.5537 3.96098 0.811537 +240 1 6.54244 2.56469 4.20941 11.0399 -32.6669 -26.4629 +241 1 8.2116 3.30444 3.37137 5.74747 4.63382 -14.2394 +242 1 0.840624 4.14226 3.27407 -5.48884 -5.61804 0.498093 +243 1 0.734437 3.23139 4.08576 22.8281 5.93798 4.2063 +244 1 0.0471721 4.13123 4.11158 -4.3827 3.27424 0.087671 +245 1 1.70286 3.20807 3.23042 -2.96775 14.0769 10.9943 +246 1 2.38769 4.13105 3.27446 4.88078 -2.82576 -1.60425 +247 1 2.4087 3.28686 4.02353 16.6104 0.201322 7.1777 +248 1 1.69983 4.0678 4.13415 -10.6977 3.91895 2.19645 +249 1 3.34377 3.23634 3.36851 -11.3528 1.51526 -17.2895 +250 1 4.2055 4.03294 3.37597 -23.3492 5.34016 -26.85 +251 1 4.03955 3.26203 4.11941 11.7033 -4.94552 16.1773 +252 1 3.21963 4.01243 4.16102 5.66091 6.82551 -5.40832 +253 1 4.83261 3.19517 3.32313 20.1816 8.52525 -2.26656 +254 1 5.77148 4.16495 3.28824 -31.489 -26.7787 -6.90732 +255 1 5.82425 3.30115 4.19401 -37.1473 -6.40083 -11.3511 +256 1 4.87724 4.09609 4.11549 36.2568 -10.3151 3.06059 +257 1 6.58329 3.33973 3.22197 0.0461967 -7.66729 -2.40242 +258 1 7.43644 4.05966 3.30265 -3.56999 5.92726 -1.37248 +259 1 7.48286 3.29775 4.19646 -3.89008 -9.4431 -11.0777 +260 1 6.47907 4.03353 4.01383 29.8324 22.3851 15.73 +261 1 8.15241 5.02846 3.31122 10.6595 -5.28085 -5.36552 +262 1 0.804631 5.8376 3.20576 13.4276 -32.1322 14.0647 +263 1 0.877129 4.8969 4.13251 -1.47043 5.42126 -0.0257482 +264 1 0.0651636 5.75976 4.1954 -9.31697 -6.72952 -15.907 +265 1 1.57617 4.92532 3.28718 5.51341 5.68743 -3.59864 +266 1 2.42583 5.72219 3.30114 4.35376 1.25963 -4.44713 +267 1 2.4551 4.89394 4.08913 0.180251 2.9051 2.6698 +268 1 1.67099 5.80732 4.08057 -5.18981 -1.73911 5.86888 +269 1 3.33413 4.84944 3.32334 -2.55875 1.02427 -1.99572 +270 1 4.20493 5.83452 3.24979 -21.4386 -63.3893 34.6056 +271 1 4.19181 4.8901 4.01924 -15.0952 14.1984 13.5631 +272 1 3.36551 5.83759 4.08786 -9.40985 -16.2604 3.57159 +273 1 4.9921 4.89151 3.36329 -7.1819 8.21085 -25.7306 +274 1 5.77026 5.74279 3.2372 -19.2661 -13.3988 15.8911 +275 1 5.68576 4.90444 4.10854 12.1482 9.27276 4.35592 +276 1 4.84395 5.80423 4.20869 23.9245 -11.025 -23.296 +277 1 6.4858 4.83859 3.18898 36.5327 24.7135 15.3623 +278 1 7.30315 5.68446 3.36881 -0.385614 18.5722 -20.0571 +279 1 7.37309 4.9455 4.05168 -2.3203 -17.2743 20.9328 +280 1 6.63896 5.83294 4.18727 -7.1922 -10.1498 -0.517575 +281 1 0.0942908 6.52233 3.3159 -35.7657 14.4096 -15.937 +282 1 0.836387 7.40457 3.20726 4.47284 -0.4112 17.4557 +283 1 0.739312 6.64758 4.08638 39.4722 -18.3951 12.5032 +284 1 8.21631 7.30153 4.06221 -15.2581 27.9702 -0.672668 +285 1 1.58758 6.54973 3.25882 10.9016 11.7867 8.01769 +286 1 2.56536 7.3619 3.34369 -76.1678 6.55793 -73.9603 +287 1 2.52556 6.61112 4.10224 -30.5256 -34.6487 7.0656 +288 1 1.62124 7.32393 4.18622 0.536802 -1.56833 -6.92191 +289 1 3.3681 6.64037 3.37818 -8.53205 -51.1792 -62.7851 +290 1 4.15298 7.36163 3.20593 -21.9528 4.612 22.3686 +291 1 4.12464 6.54108 4.035 14.4356 20.1369 22.2034 +292 1 3.19906 7.31073 4.01315 82.3215 73.9575 117.35 +293 1 4.9065 6.52075 3.26638 28.3768 26.425 6.32862 +294 1 5.74138 7.36096 3.25092 -0.970474 8.69807 4.03129 +295 1 5.81652 6.58456 4.03756 -14.737 -0.580193 0.741413 +296 1 4.87586 7.39212 4.03191 6.20313 -4.00572 5.92319 +297 1 6.48611 6.49412 3.21889 20.5434 47.1119 52.8917 +298 1 7.41876 7.4098 3.23912 -0.409624 -8.77258 11.2401 +299 1 7.35972 6.63444 4.07034 1.58562 -5.33459 -2.2315 +300 1 6.64271 7.48657 4.18074 -12.6903 -3.8877 -6.90745 +301 1 8.18545 0.00495327 4.98201 0.835961 10.4978 -8.83054 +302 1 0.830861 0.760813 4.98094 -9.95647 8.66756 -7.1447 +303 1 0.808969 0.00641337 5.74397 -4.48252 1.30502 4.67537 +304 1 0.018812 0.795135 5.84676 0.988121 0.902183 -11.1018 +305 1 1.60862 0.0119183 4.84308 17.0508 -2.91068 17.4808 +306 1 2.50239 0.876955 4.96833 -9.09304 -5.08176 -4.69214 +307 1 2.44832 8.14323 5.81234 6.77585 9.13889 -19.0494 +308 1 1.56911 0.731109 5.75394 17.4698 11.7404 -4.99849 +309 1 3.28793 0.0458368 4.91142 -7.08209 -9.95818 14.0315 +310 1 4.07208 0.823519 4.87126 26.6153 -9.6486 13.2451 +311 1 4.06672 0.0477209 5.80002 10.3282 0.566915 -15.466 +312 1 3.2042 0.88056 5.78404 3.8932 -8.75566 -1.61055 +313 1 5.02696 0.0222739 4.88991 -12.0715 4.27124 3.2294 +314 1 5.73734 0.886325 4.85298 9.71713 -6.59089 13.6933 +315 1 5.79543 0.0389128 5.76135 -3.4407 3.92019 -0.496418 +316 1 4.85161 0.780997 5.82861 2.47749 38.2945 -34.2513 +317 1 6.64858 0.0906911 4.97808 -13.982 -18.784 -13.0607 +318 1 7.30429 0.900733 5.00382 63.7384 -13.5798 -32.445 +319 1 7.4114 8.15633 5.76261 6.64498 1.40027 -2.33346 +320 1 6.66824 0.783026 5.72649 -29.5414 5.85716 47.7215 +321 1 0.0281683 1.66949 4.95949 -0.425666 -3.96058 2.91208 +322 1 0.893447 2.47998 4.9969 -1.93266 1.10148 -5.4469 +323 1 0.843715 1.6221 5.7589 -0.766033 4.56211 -3.21682 +324 1 0.0782454 2.53663 5.73256 -1.35265 -11.3593 -4.90859 +325 1 1.65079 1.66704 4.93767 -0.533365 0.139965 4.11876 +326 1 2.51601 2.38441 4.90805 0.649871 6.98133 -0.140965 +327 1 2.41175 1.72195 5.72474 2.84663 -8.86686 7.73621 +328 1 1.61538 2.54316 5.81674 -0.089029 -19.7728 -12.4678 +329 1 3.35891 1.54703 4.95536 -9.48818 22.4331 -2.56554 +330 1 4.08195 2.54313 5.01426 16.1748 -2.70068 -21.0768 +331 1 4.12034 1.74262 5.81366 10.5637 -13.2904 -3.74489 +332 1 3.37175 2.4672 5.72729 -31.5422 -3.32565 13.6818 +333 1 5.0033 1.68848 4.95948 -13.0392 -13.8401 -3.80319 +334 1 5.66589 2.47997 4.89515 25.4212 2.24436 -8.70857 +335 1 5.79028 1.55903 5.82666 2.05757 18.2253 -24.3713 +336 1 5.0311 2.46113 5.68951 -16.9377 1.04 21.5338 +337 1 6.57827 1.56896 5.01204 -21.5711 32.5342 -4.2816 +338 1 7.31623 2.52382 4.98258 18.6955 -8.52314 -2.25127 +339 1 7.45461 1.64332 5.76278 -16.0261 1.47893 -16.982 +340 1 6.64089 2.42957 5.78128 -11.0128 0.688597 0.00936653 +341 1 0.0932375 3.33117 4.94446 -5.57952 -6.38154 1.87127 +342 1 0.757472 4.19176 4.95128 10.4651 -6.09524 -1.36969 +343 1 0.907905 3.31127 5.7437 -27.4593 -10.6172 -1.55436 +344 1 0.042027 4.05791 5.75958 -12.212 5.31553 -4.25834 +345 1 1.73758 3.25237 5.02547 -7.72352 0.251809 -15.9993 +346 1 2.4871 4.0191 4.9543 -17.108 24.4302 2.09179 +347 1 2.45668 3.23081 5.78465 2.15315 9.79763 4.28788 +348 1 1.58106 4.05092 5.80356 25.1427 18.6418 -4.49313 +349 1 3.19249 3.31456 5.03239 24.0259 -22.2006 -10.8088 +350 1 4.20707 4.15779 4.866 -22.1265 -5.11578 15.6203 +351 1 4.10653 3.22389 5.85277 -11.4198 11.552 -29.8203 +352 1 3.32529 4.01575 5.8236 -9.29377 10.539 -6.33768 +353 1 5.02426 3.35158 5.01899 -31.0395 -2.45923 -24.1365 +354 1 5.68644 4.17189 4.85403 7.36649 -6.63658 10.5871 +355 1 5.74132 3.29275 5.69662 23.2126 4.63385 22.4488 +356 1 4.92531 4.19073 5.71088 -1.56015 -9.54037 12.8094 +357 1 6.54444 3.23385 4.93781 3.72392 28.1796 29.5331 +358 1 7.41233 4.02229 4.92924 -1.20364 12.0626 9.54412 +359 1 7.4663 3.28529 5.82942 -29.7597 -4.87929 -37.7444 +360 1 6.60644 4.05138 5.75927 -5.95188 5.2753 -7.63938 +361 1 8.20344 4.97671 5.0085 -9.77785 -27.0171 -16.098 +362 1 0.764125 5.65629 4.97235 19.2848 26.171 -13.514 +363 1 0.873777 4.9677 5.68286 -0.798932 -14.5746 27.2238 +364 1 8.1297 5.72693 5.67887 36.2224 14.0656 51.1647 +365 1 1.7318 5.02959 5.01529 -5.49043 -14.6131 -16.8314 +366 1 2.44542 5.85219 4.93063 19.3822 -11.3762 -19.1618 +367 1 2.55143 4.96012 5.6972 2.49476 -2.70049 4.14057 +368 1 1.7425 5.82205 5.68004 -17.6493 -28.263 45.9708 +369 1 3.3219 4.92271 4.83646 -0.36054 0.182371 1.57441 +370 1 4.15401 5.67616 4.9285 -21.3575 6.09757 11.4691 +371 1 4.07715 4.94174 5.74451 -0.595544 -7.12056 -1.40506 +372 1 3.31639 5.79418 5.70206 -6.4923 -7.4901 3.07645 +373 1 4.92581 4.94202 4.97984 -0.22012 5.90431 -14.5879 +374 1 5.73821 5.69855 4.88283 0.98112 8.81137 -0.251897 +375 1 5.70683 4.9474 5.70386 9.48927 0.653977 8.8924 +376 1 4.96412 5.79635 5.67508 -8.29845 -17.1654 19.2091 +377 1 6.48765 4.91573 4.91811 9.87445 -1.02048 -0.929801 +378 1 7.42803 5.76565 5.01887 -36.8924 9.29378 -39.8178 +379 1 7.31535 5.01349 5.75729 -2.96639 -15.6116 3.19898 +380 1 6.51112 5.80276 5.76292 -0.511839 0.0343249 -1.86567 +381 1 0.0752499 6.50198 4.93503 -9.95853 14.5519 3.18185 +382 1 0.749032 7.44313 4.93057 9.36322 -4.26106 -6.17112 +383 1 0.799308 6.59761 5.72007 7.23025 -2.947 1.48543 +384 1 0.0646916 7.47006 5.72188 -15.7332 -12.5303 9.25543 +385 1 1.64476 6.54961 5.03014 -20.9538 30.4927 -38.3434 +386 1 2.45435 7.39325 4.88002 3.42796 3.8663 5.03137 +387 1 2.4342 6.59097 5.67369 23.2905 17.249 22.0616 +388 1 1.54778 7.4679 5.8363 19.3115 -12.9738 -21.1698 +389 1 3.32159 6.57391 4.94635 0.920374 5.37222 -4.76541 +390 1 4.12734 7.43087 4.87631 0.0949958 -12.9619 14.1535 +391 1 4.03648 6.57336 5.82487 9.67898 -2.57585 -4.33725 +392 1 3.37401 7.44443 5.83215 -8.90767 -10.0262 -16.7558 +393 1 4.95785 6.5313 4.96795 -5.28369 20.3288 -12.6073 +394 1 5.72446 7.44815 4.95617 -0.295615 -4.81227 -6.28599 +395 1 5.67507 6.56368 5.75557 19.5363 2.36566 3.12879 +396 1 4.99604 7.36578 5.82253 -12.0795 7.56208 -16.0156 +397 1 6.47952 6.65183 4.84549 7.81673 -1.192 17.7565 +398 1 7.49045 7.38842 4.86267 -3.31154 -1.72952 10.3926 +399 1 7.31515 6.64393 5.7627 1.65473 -7.46902 -9.80451 +400 1 6.51213 7.44705 5.67942 6.88055 -5.46286 6.12471 +401 1 0.0806264 0.0886591 6.67061 2.86389 -53.8636 -44.0246 +402 1 0.883633 0.899989 6.55658 -11.6958 -11.9156 5.39561 +403 1 0.88757 0.0447352 7.4623 -6.5852 -8.63148 -1.54458 +404 1 0.00589996 0.782701 7.30583 -3.57511 51.2033 48.3924 +405 1 1.70878 0.0185969 6.53425 -9.91562 -0.171369 19.1044 +406 1 2.47179 0.820184 6.65916 -10.0875 0.778119 -25.3377 +407 1 2.53937 0.0160974 7.34796 -3.95783 -6.52463 5.98309 +408 1 1.62994 0.765044 7.35659 9.0133 10.535 7.11032 +409 1 3.30704 0.041501 6.48376 -12.5346 2.59741 23.4233 +410 1 4.02443 0.849646 6.63591 28.9911 -27.1685 -8.99322 +411 1 4.05271 0.0416361 7.37632 0.533135 -1.75778 -2.17869 +412 1 3.19386 0.898466 7.37702 15.4736 -11.3366 18.5812 +413 1 4.93306 0.0872445 6.49555 4.8751 -33.7979 36.6921 +414 1 5.84884 0.883258 6.55834 -5.60524 -28.829 17.1111 +415 1 5.81564 0.024621 7.40384 -2.36039 -5.56484 -6.47242 +416 1 4.961 0.816895 7.40894 -1.64345 1.03662 -2.05135 +417 1 6.67176 0.000709987 6.50931 -8.49107 -0.789231 11.0199 +418 1 7.42872 0.868407 6.55728 -5.95092 -10.3429 1.39671 +419 1 7.36138 8.18623 7.46478 9.04825 4.48366 -10.7424 +420 1 6.59985 0.825831 7.39669 4.88737 -2.34866 2.27965 +421 1 8.14416 1.67759 6.49013 32.825 -1.32457 17.7447 +422 1 0.9037 2.40379 6.60352 -22.6991 13.3728 -5.6252 +423 1 0.83815 1.6821 7.34463 -6.45777 -9.82884 14.5288 +424 1 8.19206 2.55987 7.48041 1.09967 -24.6646 -31.5822 +425 1 1.61029 1.6565 6.61062 19.3859 -4.50632 -8.40911 +426 1 2.39042 2.47779 6.49991 10.3869 -7.14038 20.8685 +427 1 2.43336 1.66264 7.31159 -0.298923 7.67874 9.60508 +428 1 1.68521 2.53757 7.43341 0.0908995 -20.3899 -19.4953 +429 1 3.34574 1.55658 6.57542 -29.1499 40.141 -5.99747 +430 1 4.09567 2.50385 6.58715 2.92988 -17.1157 8.90269 +431 1 4.06967 1.60141 7.36073 8.28003 9.68724 13.2999 +432 1 3.26291 2.44686 7.41755 -1.72761 -1.27824 0.484775 +433 1 5.02343 1.63061 6.57358 -10.9076 3.24904 2.06921 +434 1 5.8117 2.52535 6.48584 -2.10788 -3.23133 8.48842 +435 1 5.76381 1.64883 7.37339 7.06147 -0.584215 3.21917 +436 1 4.99697 2.44099 7.45915 -1.75923 11.2498 -19.4182 +437 1 6.62044 1.59458 6.63611 -5.65576 11.9066 -13.6974 +438 1 7.40085 2.40641 6.52565 -4.26631 17.0681 5.6259 +439 1 7.4086 1.68173 7.30269 7.67403 -2.22025 20.1658 +440 1 6.56414 2.4958 7.48155 2.02857 -0.65966 -9.40352 +441 1 8.16172 3.22 6.50779 31.0613 6.17733 37.0029 +442 1 0.778923 4.13348 6.47989 7.10682 -1.13444 17.3069 +443 1 0.731543 3.38344 7.32104 8.57141 -10.8353 -0.596329 +444 1 8.20703 4.11651 7.39737 -10.5501 6.3503 -2.89453 +445 1 1.5556 3.22612 6.62242 10.8567 18.3759 1.80723 +446 1 2.43596 4.07218 6.65191 19.5996 1.93234 -23.7547 +447 1 2.42128 3.38357 7.48855 6.46322 -13.7769 -4.42002 +448 1 1.70183 4.1306 7.3251 -28.6202 8.98318 18.3174 +449 1 3.23368 3.21004 6.55845 -1.66335 0.810928 5.98502 +450 1 4.02817 4.01745 6.59179 9.73332 14.3603 -1.234 +451 1 4.04024 3.24371 7.33596 9.19519 -2.61436 13.2612 +452 1 3.33578 4.03204 7.3761 -11.8519 11.1256 7.31388 +453 1 4.84615 3.34919 6.50516 30.474 -3.21025 16.5113 +454 1 5.79338 4.10407 6.63223 -1.4488 4.34379 -6.9657 +455 1 5.71769 3.33306 7.36343 3.56485 -8.31237 5.17357 +456 1 4.89884 4.06687 7.36632 1.94898 -1.38193 2.81677 +457 1 6.61297 3.34048 6.58436 -38.9416 -40.8203 -5.50523 +458 1 7.30794 4.01061 6.56591 40.2005 61.5018 -17.6954 +459 1 7.37741 3.36957 7.31145 38.0889 -52.6112 27.9446 +460 1 6.66665 4.01974 7.42717 -35.3166 42.1921 1.19147 +461 1 0.0452175 4.90338 6.62118 -6.71352 5.92623 -3.01906 +462 1 0.869367 5.66645 6.62279 -29.6122 19.3042 -24.6336 +463 1 0.858776 5.03104 7.45654 -16.814 -24.2615 8.51744 +464 1 8.14658 5.74936 7.4724 2.5583 -5.40279 -7.71149 +465 1 1.59957 4.95319 6.53572 14.873 -15.6204 -6.12191 +466 1 2.54529 5.66468 6.59785 -23.4011 43.3591 -27.461 +467 1 2.4961 5.03005 7.34302 -11.668 -32.1864 28.6337 +468 1 1.60544 5.69113 7.30132 37.8442 13.2739 23.8753 +469 1 3.24356 4.96073 6.59142 26.8133 -25.0989 -5.08933 +470 1 4.09781 5.67439 6.52285 2.63557 7.15813 7.05447 +471 1 4.18105 4.86276 7.35501 -9.07005 4.72655 -1.53462 +472 1 3.36767 5.65499 7.49749 6.09099 26.0319 -27.9028 +473 1 5.01795 4.94278 6.59504 -2.00637 0.995546 -1.6799 +474 1 5.7841 5.85399 6.63871 4.06216 -12.0086 -14.5693 +475 1 5.83404 5.02565 7.38856 -29.8707 -40.8918 -9.03319 +476 1 4.9605 5.83878 7.31445 -12.603 -27.5006 25.6094 +477 1 6.59477 4.88222 6.67554 -4.07568 1.88148 -17.9737 +478 1 7.35313 5.77701 6.52551 0.181186 3.4052 7.13046 +479 1 7.348 4.89641 7.37973 13.5892 1.99375 8.82978 +480 1 6.49663 5.74982 7.4422 46.6685 29.9241 -18.7201 +481 1 0.0491078 6.53098 6.47716 -5.83531 -0.141054 6.60445 +482 1 0.791488 7.40292 6.50563 -8.70546 -0.874788 22.49 +483 1 0.919931 6.51323 7.45776 -11.5314 25.4002 -28.1718 +484 1 0.0481113 7.40468 7.43229 -11.5944 -5.37754 -18.7674 +485 1 1.63473 6.52345 6.62888 -0.301482 5.86022 -13.1885 +486 1 2.54325 7.3746 6.52095 -7.01617 -1.6126 8.94816 +487 1 2.42821 6.65367 7.34715 -0.0947462 -6.49261 12.3075 +488 1 1.66344 7.43005 7.38619 -4.64698 1.83667 -2.7903 +489 1 3.21223 6.51896 6.65614 12.5802 -0.344258 -7.45446 +490 1 4.18524 7.3836 6.50889 -0.948752 5.15796 16.6381 +491 1 4.03479 6.58867 7.43482 10.4531 -7.07785 -21.0648 +492 1 3.31132 7.44815 7.43351 -1.0832 -4.66317 -4.42978 +493 1 5.00814 6.58691 6.66459 -15.2308 20.9466 -24.4589 +494 1 5.70889 7.39626 6.56563 14.4769 6.85637 10.1092 +495 1 5.73775 6.567 7.43094 6.72915 9.63092 8.95959 +496 1 4.91068 7.49261 7.37168 0.330155 -8.28614 -9.94049 +497 1 6.53726 6.65021 6.66417 -1.59265 -6.08794 -3.67401 +498 1 7.37246 7.29875 6.57444 7.56141 13.3939 8.59342 +499 1 7.35261 6.58373 7.49207 23.0737 -16.5957 -35.2353 +500 1 6.60589 7.39349 7.49219 -10.7096 3.92482 -19.5185 diff --git a/examples/mdi/dump.17Jun22.series.driver.plugin.3 b/examples/mdi/dump.17Jun22.series.driver.plugin.3 new file mode 100644 index 0000000000..847432833a --- /dev/null +++ b/examples/mdi/dump.17Jun22.series.driver.plugin.3 @@ -0,0 +1,1527 @@ +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +500 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 8.9390353509656766e+00 +0.0000000000000000e+00 8.9390353509656766e+00 +0.0000000000000000e+00 8.9390353509656766e+00 +ITEM: ATOMS id type x y z f_1[1] f_1[2] f_1[3] +1 1 0.0109462 8.91109 8.87705 -0.258023 0.625273 0.429284 +2 1 0.983178 0.93542 8.91066 -2.88593 0.281032 -1.95154 +3 1 0.886776 0.00353842 0.964105 -0.27179 0.383251 0.443719 +4 1 0.0722273 0.817966 0.815708 -0.663834 1.25489 -0.35451 +5 1 1.82919 8.8603 8.91164 0.346262 0.966337 0.327185 +6 1 2.71374 0.850558 0.0977971 -1.53533 0.952301 -0.539148 +7 1 2.75443 8.9152 0.943835 0.200679 -0.0265554 -0.862232 +8 1 1.72161 0.971413 0.796705 7.79754 -6.0811 1.58835 +9 1 3.47837 0.0294075 0.0515782 2.76325 -2.21894 -0.80311 +10 1 4.43186 0.961325 8.89919 -0.387918 -0.444884 0.950878 +11 1 4.37764 0.00631327 0.801109 0.844344 -0.87322 -0.116598 +12 1 3.59567 0.80748 0.974874 -0.705778 1.85625 -1.80855 +13 1 5.35026 8.89566 0.0208816 -0.442875 -0.272596 -0.473028 +14 1 6.3022 0.978028 0.0782288 -3.05518 -2.94099 -0.889505 +15 1 6.27707 0.0297536 0.962734 -0.0515917 0.772188 -1.05602 +16 1 5.30223 0.918655 0.899444 1.33545 0.759601 -1.29769 +17 1 7.0769 0.0948096 0.0649153 0.098645 -1.06535 0.292165 +18 1 8.09537 0.913626 0.0774105 -0.154847 0.414543 -0.451754 +19 1 8.08165 0.0818588 0.895196 -0.689773 -1.28143 0.929968 +20 1 7.14638 0.885276 0.891299 0.487793 0.733541 0.918445 +21 1 8.89456 1.84483 0.0434425 0.886905 -0.621358 -0.495646 +22 1 0.935681 2.64324 0.0406455 -1.34335 0.213362 -1.25695 +23 1 0.966071 1.69976 0.948945 -7.88058 11.3257 -7.25569 +24 1 0.0121607 2.66637 0.881115 -0.232812 0.533689 1.18415 +25 1 1.85044 1.81859 0.00192994 -1.7495 0.19048 0.1992 +26 1 2.68148 2.7251 0.0685109 -1.25528 -0.916148 -1.01459 +27 1 2.62716 1.70715 0.839166 0.688023 2.33788 1.05919 +28 1 1.6905 2.59418 0.903739 1.58905 0.257971 0.508129 +29 1 3.57454 1.77719 8.88663 0.186742 -0.0628404 0.80372 +30 1 4.38099 2.63699 8.92556 0.253897 0.0578989 -0.178058 +31 1 4.45919 1.78484 0.892793 0.372262 0.580252 -1.28381 +32 1 3.55804 2.657 0.821946 0.208194 0.440929 1.42052 +33 1 5.39579 1.85576 0.0513097 -2.11231 -0.770148 -0.833202 +34 1 6.28486 2.68552 0.0861957 -0.390024 -0.099671 -1.25573 +35 1 6.16167 1.79587 0.852166 3.13123 -0.282736 3.8241 +36 1 5.43841 2.67896 0.926914 -0.906522 -0.132525 -0.585389 +37 1 7.09214 1.72405 8.83985 3.26876 6.20695 4.03515 +38 1 7.96694 2.76043 0.0935037 2.29966 -0.680397 -1.28039 +39 1 8.06525 1.69772 0.940378 0.498274 0.445905 0.0355574 +40 1 7.16698 2.58338 0.88179 -1.8895 -0.0707859 1.12114 +41 1 0.0210451 3.48041 0.0428158 0.862491 -0.329006 -0.681709 +42 1 0.874431 4.40275 0.0131769 0.218928 -0.148848 0.324321 +43 1 0.851364 3.60752 0.914082 0.352487 -0.527665 -0.410754 +44 1 0.0749717 4.51844 0.974577 -0.257295 -0.287753 -0.288054 +45 1 1.76248 3.58626 0.0539576 0.480316 -2.29368 -1.63127 +46 1 2.72367 4.4241 0.0474256 0.0272964 0.241712 -0.452415 +47 1 2.73289 3.61199 0.901343 -0.0645249 -1.94992 -0.502421 +48 1 1.8456 4.38069 0.843492 -0.349918 1.31176 2.27682 +49 1 3.50387 3.55674 0.0315796 1.56114 -0.0224047 0.116984 +50 1 4.49692 4.37908 0.0780585 -4.54206 0.213106 -5.58215 +51 1 4.46671 3.57478 0.880458 -0.334204 -0.938728 0.874478 +52 1 3.58815 4.43 0.950374 0.652985 -1.92511 -1.59862 +53 1 5.3866 3.58372 8.92789 -1.19711 -2.22155 0.617325 +54 1 6.17276 4.37217 8.86047 6.00842 1.34471 4.78274 +55 1 6.27432 3.53871 0.907449 -0.148389 -0.137473 -0.523414 +56 1 5.27909 4.47835 0.809401 8.23917 -3.14067 4.34956 +57 1 7.09737 3.53698 8.87413 0.14026 -0.233191 0.941929 +58 1 7.96586 4.56922 8.84208 6.8748 -6.48505 1.75868 +59 1 8.1189 3.63425 0.96148 -3.00277 -1.46323 -4.15536 +60 1 7.14279 4.43222 0.962078 -0.0459577 0.247999 0.321752 +61 1 8.89637 5.43177 8.92691 0.327116 0.812268 0.0679643 +62 1 0.854018 6.30348 0.0813318 1.06274 -7.24911 -7.87042 +63 1 0.873415 5.41923 0.812761 -0.31071 -0.409433 0.423823 +64 1 8.88236 6.35419 0.863575 -0.753758 -3.06962 -0.690381 +65 1 1.76334 5.40934 8.88249 1.8326 1.29836 1.91996 +66 1 2.68777 6.21767 8.90577 0.0461489 1.51967 -0.262666 +67 1 2.66088 5.41906 0.821357 0.262109 -0.890774 -0.241847 +68 1 1.86017 6.31332 0.804602 -1.38053 -1.13952 0.850174 +69 1 3.64435 5.42051 8.90358 -2.6101 -2.17442 -0.370474 +70 1 4.37466 6.25131 8.85278 3.71832 2.70453 0.946098 +71 1 4.53047 5.2708 0.824393 -3.54051 3.8431 0.931364 +72 1 3.61222 6.27635 0.96909 -4.05414 0.604922 -3.58471 +73 1 5.40042 5.34751 8.8935 -0.719369 -0.36085 0.212296 +74 1 6.18215 6.3156 0.0196993 0.267387 0.110688 0.223648 +75 1 6.27516 5.37868 0.90209 -1.0642 -0.241069 0.481931 +76 1 5.31268 6.25584 0.875522 0.133781 0.115172 0.026661 +77 1 7.20113 5.30633 8.84474 -4.87308 6.78349 0.0391413 +78 1 7.95512 6.30497 0.092705 6.00614 -6.0265 -0.649957 +79 1 8.08767 5.35538 0.811364 -1.15126 0.392579 0.741715 +80 1 7.08607 6.1919 0.926051 0.630581 3.46407 -2.46157 +81 1 8.92405 7.0566 8.88782 -1.53371 0.564813 -0.0213323 +82 1 0.905011 8.13513 0.0600006 -0.504969 -0.194195 -0.00181653 +83 1 0.816253 7.07033 0.801556 1.36958 7.74762 7.34595 +84 1 8.83925 8.07727 0.907684 2.46931 1.67506 1.17354 +85 1 1.86043 7.09328 8.91972 -0.773441 0.857837 1.39948 +86 1 2.76541 7.99166 0.0440794 -0.77809 1.05822 0.425741 +87 1 2.67654 7.18636 0.91183 2.62219 -2.00002 -0.219028 +88 1 1.8788 7.9677 0.915621 -0.894934 2.07357 -1.21117 +89 1 3.59357 7.13026 0.0332195 -0.388167 0.00237965 -0.544686 +90 1 4.38663 8.07233 8.88382 0.174711 -0.440379 0.0897133 +91 1 4.5359 7.22854 0.936578 -2.37627 -1.04519 -2.35662 +92 1 3.63538 7.97981 0.824881 -1.61206 1.29888 2.0997 +93 1 5.3271 7.23059 8.92328 -0.111431 -0.20975 0.289951 +94 1 6.30867 8.05581 8.84577 0.0946421 0.0525728 2.57365 +95 1 6.32003 7.15576 0.891457 -0.2569 -0.483959 0.0547371 +96 1 5.40661 7.9868 0.968462 0.415884 0.0845497 -0.268424 +97 1 7.22798 7.08713 0.0563741 -5.45853 5.72078 -0.51002 +98 1 8.05735 8.06186 0.0753342 -0.611004 1.73052 -2.95918 +99 1 8.10922 7.21906 0.806609 -0.400473 -2.4357 2.42821 +100 1 7.16998 8.08498 0.846622 0.253892 0.388538 0.000271703 +101 1 8.88419 0.00785958 1.88382 0.148531 -0.55276 -3.06718 +102 1 0.806706 0.963107 1.6981 0.146821 -6.1479 7.24676 +103 1 0.81371 8.93107 2.59291 1.58623 0.25767 2.66866 +104 1 0.0914118 0.851308 2.7806 -2.96193 1.34432 -3.85013 +105 1 1.70908 0.055279 1.86232 -0.26684 0.0875329 -0.306957 +106 1 2.72497 0.940903 1.70203 -0.757536 -0.918748 1.71384 +107 1 2.71129 0.0639965 2.67102 -0.311468 0.261861 0.646041 +108 1 1.73889 0.96912 2.64369 0.123913 0.173982 0.666446 +109 1 3.52533 0.0194588 1.83263 1.01391 -0.00454228 -0.284845 +110 1 4.50633 0.992013 1.70842 -3.51938 -2.99082 2.23564 +111 1 4.49463 8.9275 2.60712 -6.23135 -0.421499 6.59704 +112 1 3.51061 0.932206 2.63613 0.265327 0.172351 0.555119 +113 1 5.26459 0.0845656 1.88118 6.41483 1.44516 -5.35427 +114 1 6.26822 0.943133 1.78953 -0.172034 -0.0988047 -0.238973 +115 1 6.20352 0.0931252 2.63772 -0.251863 0.451194 0.97073 +116 1 5.33497 0.961022 2.74861 1.85573 -2.10168 -0.655218 +117 1 7.15143 8.91799 1.69931 0.631991 0.791476 -0.168042 +118 1 8.1075 0.884637 1.85069 -0.145764 0.238097 -0.736312 +119 1 8.10277 0.00424992 2.71008 -1.61591 0.00687295 -1.36275 +120 1 7.06485 0.985537 2.76239 8.19773 -7.92397 -1.18231 +121 1 8.91698 1.83538 1.78872 0.656642 -0.0731624 0.0431027 +122 1 0.901335 2.58954 1.84197 -0.375827 -0.324571 -2.7055 +123 1 0.839546 1.79651 2.68072 1.09251 -0.901613 -0.242728 +124 1 0.0205195 2.75315 2.62687 -0.478759 -0.0106512 -0.67727 +125 1 1.78258 1.70562 1.69835 1.31189 0.545066 2.20675 +126 1 2.77409 2.6552 1.77928 -3.71202 0.456863 -3.25075 +127 1 2.62583 1.79361 2.77487 3.4762 0.328618 -3.48584 +128 1 1.71155 2.69761 2.62919 0.862289 -1.38539 2.38335 +129 1 3.5477 1.79572 1.86096 1.43061 -0.605958 -0.978191 +130 1 4.46749 2.5924 1.76238 -0.0494618 -0.0821277 -0.176353 +131 1 4.52929 1.74324 2.59829 -2.00749 0.662049 0.061349 +132 1 3.48188 2.69682 2.61959 1.88694 -0.141301 3.78311 +133 1 5.34711 1.71486 1.76809 1.96327 2.17405 -0.830705 +134 1 6.24637 2.73306 1.80484 3.10489 -2.12999 -0.788559 +135 1 6.31443 1.71423 2.71392 -8.21546 8.18972 -0.602972 +136 1 5.26572 2.69815 2.75971 0.0267628 0.10355 -0.216257 +137 1 7.18953 1.75159 1.71849 -0.576203 -0.36263 1.38792 +138 1 8.05027 2.77408 1.76451 0.439173 -0.587966 -0.341117 +139 1 8.01591 1.69661 2.74434 0.366947 0.0491547 0.134545 +140 1 7.14772 2.69371 2.58907 0.0738449 -1.92773 2.13155 +141 1 8.86781 3.66165 1.74517 3.90719 -1.47472 3.87657 +142 1 0.936621 4.42773 1.79512 -0.401045 -0.147867 0.321366 +143 1 0.948846 3.59531 2.72105 -0.571635 -0.0105131 -1.06193 +144 1 0.0834486 4.38982 2.63588 -0.524533 1.06652 0.75481 +145 1 1.83432 3.4799 1.75691 0.359017 0.665628 -0.818381 +146 1 2.69175 4.37077 1.75144 0.14004 0.214725 0.925417 +147 1 2.74153 3.6404 2.67912 -0.708299 -3.83642 -3.24565 +148 1 1.87968 4.54846 2.67269 -0.684796 -0.993828 -0.138535 +149 1 3.5441 3.51573 1.77434 0.186245 0.881611 -0.696526 +150 1 4.55171 4.52396 1.79145 -2.75839 -2.91024 -1.57263 +151 1 4.49896 3.65335 2.59498 -1.96388 -1.7196 0.869652 +152 1 3.49741 4.47737 2.77344 8.37692 1.8085 -7.7175 +153 1 5.44145 3.48872 1.74764 -3.05421 3.82286 1.14399 +154 1 6.1743 4.53053 1.74574 0.463366 -1.70291 0.122224 +155 1 6.30198 3.67131 2.70975 -1.07292 -0.185523 -2.51985 +156 1 5.34196 4.38653 2.7007 1.29125 2.52938 -0.102964 +157 1 7.1691 3.54339 1.87445 -0.749456 2.7751 -2.56091 +158 1 7.97266 4.40051 1.79603 0.56071 1.27489 1.72891 +159 1 7.99234 3.49992 2.67525 0.940044 2.40885 0.128516 +160 1 7.18063 4.50303 2.68825 -0.923025 -2.40154 0.0954191 +161 1 8.91159 5.33038 1.82507 -0.0203349 -0.241672 0.333237 +162 1 0.8958 6.32359 1.78851 0.38501 -0.14702 -0.347965 +163 1 0.943571 5.31749 2.71754 -0.318578 -0.34148 0.397124 +164 1 0.0864418 6.28418 2.68726 -1.86154 0.137969 -3.27119 +165 1 1.71465 5.37463 1.6949 -0.232891 -0.268012 0.301526 +166 1 2.72852 6.31988 1.88644 -2.78715 -2.37305 -5.95735 +167 1 2.64735 5.41101 2.73193 1.7471 0.192556 0.973026 +168 1 1.84919 6.27948 2.72157 -0.39498 0.808971 -0.0974847 +169 1 3.48336 5.2657 1.71665 0.625214 2.24561 1.33995 +170 1 4.39296 6.19435 1.72952 3.81534 -0.586193 2.86006 +171 1 4.52517 5.37564 2.62027 -1.99502 -0.45422 2.59567 +172 1 3.56333 6.24537 2.5877 2.83084 0.938216 3.4987 +173 1 5.32581 5.29562 1.86847 5.13697 3.80601 -2.04537 +174 1 6.24758 6.22298 1.79203 0.477004 0.378689 0.56244 +175 1 6.25283 5.44934 2.73731 1.14422 -0.830366 -0.337224 +176 1 5.45416 6.25624 2.6996 -2.42774 -1.74418 -0.22606 +177 1 7.22676 5.41803 1.71412 0.223451 -2.28899 2.0191 +178 1 8.0979 6.3518 1.78861 -0.44204 -0.435572 -0.338725 +179 1 8.01325 5.26918 2.64973 1.18264 0.878361 -0.124926 +180 1 7.11991 6.34415 2.69936 -1.3293 -2.66755 2.78128 +181 1 0.0635545 7.11209 1.72165 -0.371894 2.049 0.790012 +182 1 0.857409 8.07873 1.82753 -0.608672 -0.60495 -0.46291 +183 1 0.930573 7.24697 2.65225 -4.55248 -4.69883 0.513873 +184 1 8.8491 7.95414 2.58819 0.570786 1.09764 -0.00497061 +185 1 1.71811 7.19809 1.77835 0.893245 -0.692356 0.118249 +186 1 2.78024 8.04523 1.70672 -2.88976 2.48107 0.040135 +187 1 2.67012 7.13476 2.61708 -1.16009 2.6938 3.43626 +188 1 1.72659 7.99584 2.64342 2.19305 3.0992 -0.0129086 +189 1 3.48631 7.23394 1.84989 5.35093 -4.92393 -2.00054 +190 1 4.4261 8.04744 1.77118 -0.338387 -0.0128497 0.448007 +191 1 4.41287 7.13619 2.73708 2.81119 1.17101 -3.79683 +192 1 3.52255 7.96143 2.73527 1.04353 0.896155 0.0445218 +193 1 5.31509 7.09458 1.73703 1.75862 -0.357986 2.37379 +194 1 6.31592 8.04277 1.87992 0.07968 -0.344084 0.021952 +195 1 6.19476 7.08883 2.7194 5.13464 2.37882 -2.53303 +196 1 5.31616 7.97076 2.64032 0.139732 0.0575338 -0.0995313 +197 1 7.13779 7.0901 1.87785 -0.856279 1.84142 -1.45962 +198 1 8.00182 8.12007 1.73344 0.812689 0.333431 -0.248462 +199 1 8.01591 7.08327 2.73264 -0.0756439 0.769292 0.331432 +200 1 7.15074 8.00152 2.76416 1.82643 0.942676 -3.56152 +201 1 8.89655 8.9304 3.48678 1.65951 -0.447815 3.8493 +202 1 0.950495 0.819015 3.5162 -1.29532 1.69106 1.16913 +203 1 0.81801 0.0539921 4.51501 3.2278 -0.258036 -5.15445 +204 1 8.85177 0.90744 4.37372 14 -2.90794 10.8129 +205 1 1.78019 0.0426842 3.56938 1.84169 -0.836001 -0.350651 +206 1 2.63146 0.926366 3.57031 0.012479 0.082004 0.331715 +207 1 2.70742 0.0633514 4.41591 -1.37547 -1.33331 0.456319 +208 1 1.7142 0.801654 4.43761 0.662356 1.10176 0.272549 +209 1 3.65397 8.84382 3.54877 -3.56671 5.39916 0.463391 +210 1 4.3911 0.894602 3.52171 0.595814 -0.346452 0.321605 +211 1 4.50401 0.046887 4.49909 -1.14502 -0.949582 -0.274225 +212 1 3.51809 0.843433 4.41351 1.90854 2.37085 -0.229306 +213 1 5.34066 0.0102546 3.52427 -0.108558 0.828678 0.2339 +214 1 6.2908 0.991162 3.59141 -5.23018 -9.53106 -1.9323 +215 1 6.23033 0.0280237 4.46344 1.30838 0.516693 -1.50043 +216 1 5.29132 0.919899 4.38256 0.973507 -2.91573 1.14051 +217 1 7.06389 8.92307 3.63529 1.41369 0.894395 -0.0234904 +218 1 8.13244 0.926287 3.63848 -11.0259 -0.689673 -11.6462 +219 1 8.07431 0.0396355 4.42295 -0.0998371 -0.343464 -0.2111 +220 1 7.15426 0.902415 4.51611 0.37609 -0.87238 -0.174942 +221 1 0.0547819 1.70767 3.52402 -0.0990054 0.634623 1.9504 +222 1 0.990251 2.59589 3.64321 -1.70133 -1.15531 -1.34459 +223 1 0.876254 1.75025 4.46545 0.108846 -0.46015 0.445192 +224 1 8.851 2.6248 4.52232 3.89545 -0.330965 -5.02573 +225 1 1.83233 1.81735 3.53725 -2.40083 -0.602726 2.24699 +226 1 2.73685 2.66072 3.63237 -1.34367 -0.0545412 -0.555358 +227 1 2.76889 1.75912 4.53924 -5.46261 0.887424 -6.31803 +228 1 1.79935 2.60963 4.48075 0.43952 -0.293553 0.768966 +229 1 3.51296 1.81737 3.56522 0.159577 -1.35984 0.863711 +230 1 4.48313 2.73941 3.65804 -0.990489 -8.98093 -5.87222 +231 1 4.37894 1.70897 4.40451 -1.1595 -0.0369555 -0.272198 +232 1 3.5578 2.69572 4.44594 -0.0317478 -0.740538 0.514717 +233 1 5.41644 1.73157 3.63972 -0.214907 2.94643 -2.78853 +234 1 6.22995 2.60145 3.56616 -0.0106554 -0.60109 0.383738 +235 1 6.30303 1.6885 4.42264 -3.32083 3.037 6.44969 +236 1 5.43404 2.73282 4.52181 -0.69148 0.715375 -0.475461 +237 1 7.08666 1.7162 3.65955 7.29974 4.17951 -2.48105 +238 1 8.0318 2.68816 3.49666 -0.181832 0.425298 0.461358 +239 1 8.08432 1.70749 4.5149 -2.31295 1.75558 0.820722 +240 1 7.18431 2.71452 4.51289 0.136997 -0.067144 0.521486 +241 1 8.84691 3.61245 3.64188 4.42683 -0.879675 -3.24184 +242 1 0.916797 4.43325 3.62545 -0.842258 -0.010797 0.0107287 +243 1 0.871748 3.60004 4.51194 -0.301498 0.107107 -0.324598 +244 1 8.92426 4.51452 4.44006 -0.00859866 -1.77564 -0.547037 +245 1 1.68965 3.48331 3.5995 1.50205 1.26015 1.14935 +246 1 2.74619 4.38356 3.49878 -7.16717 1.90489 10.07 +247 1 2.74519 3.65012 4.52097 -2.02388 -3.55766 -1.13857 +248 1 1.75432 4.38414 4.53252 -0.421779 0.409337 0.409015 +249 1 3.58997 3.49254 3.52387 -0.821723 1.10659 0.0739307 +250 1 4.40569 4.52296 3.53187 0.545495 -0.966363 -0.0502063 +251 1 4.38156 3.4874 4.39271 -0.289264 8.2647 7.79533 +252 1 3.54333 4.42257 4.55563 2.80723 11.1106 -9.83606 +253 1 5.27331 3.5295 3.65482 2.61308 2.66186 -0.969787 +254 1 6.16108 4.46828 3.59956 0.599894 -1.41883 -0.240371 +255 1 6.22639 3.63251 4.44985 -0.305031 -0.480252 0.0742084 +256 1 5.31568 4.40222 4.46767 -0.344747 -0.443719 0.00587924 +257 1 7.10015 3.56367 3.49443 2.55034 0.169304 1.35525 +258 1 8.02171 4.37546 3.5697 -1.76106 3.37709 -2.28074 +259 1 8.069 3.64942 4.40708 -2.31714 -3.33053 6.18677 +260 1 7.18438 4.37135 4.52245 -1.79563 0.274401 -0.392524 +261 1 0.0758128 5.3487 3.5652 0.184463 -0.360483 0.192319 +262 1 0.795174 6.30898 3.53894 9.14413 -6.75396 2.48214 +263 1 0.867482 5.30202 4.453 0.791187 0.0370161 0.388706 +264 1 0.00225224 6.31064 4.52093 0.402626 -0.0990512 0.0415993 +265 1 1.75224 5.26394 3.64332 0.696547 0.221295 -0.114908 +266 1 2.74065 6.24856 3.64631 -0.500385 1.40459 -1.64071 +267 1 2.73855 5.4528 4.44688 -5.40773 -5.67129 2.9343 +268 1 1.74472 6.17623 4.53641 0.82995 0.717951 -0.0718944 +269 1 3.48421 5.34442 3.61728 1.66736 -1.06074 -1.09811 +270 1 4.41383 6.35055 3.60638 9.51906 -9.2799 1.43724 +271 1 4.38632 5.26464 4.48258 -0.919101 0.504742 0.900072 +272 1 3.55793 6.1617 4.49469 4.34711 2.82736 -0.340092 +273 1 5.36863 5.28325 3.49178 -0.734818 0.617922 -0.744768 +274 1 6.26503 6.19943 3.66319 0.429882 1.55809 -2.03015 +275 1 6.35487 5.3413 4.44757 0.561767 -0.978785 -0.133344 +276 1 5.27408 6.24166 4.56754 6.98603 1.54355 -5.42942 +277 1 7.19701 5.44828 3.47564 -5.73363 -4.54905 0.0826653 +278 1 7.95668 6.19688 3.55501 6.31824 5.03885 -1.22951 +279 1 8.09251 5.32103 4.3972 -0.525971 0.388914 -0.470954 +280 1 7.21521 6.34275 4.38759 -5.30552 -2.8442 0.851377 +281 1 0.0775826 7.08234 3.53581 -5.46769 7.72822 0.0708503 +282 1 0.933572 7.95134 3.59844 -0.0755868 -0.81045 -0.0294233 +283 1 0.967321 7.07254 4.42487 -1.68738 -0.0136546 1.81969 +284 1 8.87247 7.95576 4.3937 0.743652 0.272325 -0.92866 +285 1 1.76917 7.11669 3.64005 0.930468 -0.723585 -1.50003 +286 1 2.76456 8.10499 3.62233 -0.317456 0.121935 0.766743 +287 1 2.61456 7.10311 4.56718 0.759736 -0.536182 -1.28605 +288 1 1.85332 7.96709 4.49102 -0.903085 0.0612931 0.171005 +289 1 3.6668 7.06536 3.52857 -12.7314 9.15268 1.72289 +290 1 4.37522 8.04334 3.61636 3.8155 -4.43194 -0.0509001 +291 1 4.53661 7.19684 4.42303 -0.089737 0.0836956 0.326132 +292 1 3.62847 8.06443 4.56174 -6.53673 1.14979 -7.53287 +293 1 5.44626 7.09379 3.53396 -2.70855 0.0837127 2.61511 +294 1 6.30058 8.08668 3.48692 -3.50797 -0.210369 1.40313 +295 1 6.24642 7.05504 4.56658 1.23504 0.486666 -1.51311 +296 1 5.40389 8.14153 4.41484 -1.1149 -1.90428 -2.07503 +297 1 7.0793 7.23572 3.56625 0.390898 -5.13728 0.366365 +298 1 8.02564 8.11993 3.55841 -0.989908 -0.0289504 0.0817166 +299 1 7.96341 7.11444 4.5691 3.18586 3.20848 -0.902141 +300 1 7.14662 7.9965 4.39373 -0.0363915 0.663241 1.28885 +301 1 0.0665117 0.0620058 5.29566 -4.76408 0.0634028 3.8487 +302 1 0.920378 0.847838 5.33345 0.704711 1.73157 1.07432 +303 1 0.90733 0.0507073 6.29492 -0.256865 0.383558 -0.568888 +304 1 0.0695806 0.935871 6.21245 0.520609 -0.18085 0.460935 +305 1 1.7158 8.90069 5.2688 0.480844 0.845699 -0.0820744 +306 1 2.72956 0.862321 5.35582 -0.666933 0.680843 -0.243728 +307 1 2.75788 8.89573 6.26927 0.729554 0.867268 -0.717865 +308 1 1.87787 0.918127 6.17945 -0.463015 -0.230718 0.375845 +309 1 3.57292 0.0827463 5.28099 -0.282881 -3.17985 0.660183 +310 1 4.39889 0.831174 5.46088 -0.653335 9.17872 -7.1909 +311 1 4.53367 0.077487 6.1821 0.157227 -8.03625 7.38236 +312 1 3.56635 0.935389 6.31146 0.221361 0.0036999 -1.2625 +313 1 5.44773 8.84526 5.27719 -1.51548 1.46139 3.00719 +314 1 6.272 0.802404 5.33609 -0.667532 1.91594 -0.251293 +315 1 6.22537 8.89219 6.16591 -0.245349 -0.895062 1.43446 +316 1 5.33827 0.94153 6.32303 -1.13614 0.583964 -0.338203 +317 1 7.11863 0.0577427 5.44516 0.0248025 -1.55594 -0.512164 +318 1 7.97781 0.796351 5.39903 0.844611 2.54625 -2.84321 +319 1 8.06017 8.92765 6.18069 -0.104306 -2.31947 1.77241 +320 1 7.18164 0.989783 6.31023 -0.163547 -0.192109 -0.79717 +321 1 0.0916103 1.88258 5.39516 -1.00186 -1.43206 -0.661702 +322 1 0.982314 2.60245 5.42151 0.964023 2.57135 -1.73713 +323 1 0.897632 1.84422 6.25233 0.598171 -0.657266 0.69786 +324 1 0.0925235 2.7239 6.16577 -1.60764 0.211114 1.61705 +325 1 1.82959 1.77578 5.39133 -0.293694 0.755656 -0.589776 +326 1 2.69272 2.74727 5.44011 1.7292 -2.84836 -1.30998 +327 1 2.6889 1.83234 6.17525 0.647659 -0.90616 0.231454 +328 1 1.77521 2.70825 6.28078 0.536701 -0.406727 0.0293567 +329 1 3.51954 1.69427 5.29216 6.69261 0.0739574 6.33581 +330 1 4.4097 2.73314 5.34432 0.344675 0.135757 -0.187596 +331 1 4.40444 1.82369 6.16689 4.836 -4.97823 0.364517 +332 1 3.67178 2.60038 6.25743 -5.49724 5.54416 -0.00203516 +333 1 5.35146 1.77827 5.39473 -0.235283 0.213892 0.835574 +334 1 6.28399 2.77802 5.42862 -0.340126 -0.250486 -0.411738 +335 1 6.23134 1.81375 6.22687 0.0223138 0.244736 0.523936 +336 1 5.32351 2.70513 6.28288 3.08354 -1.69468 -3.77436 +337 1 7.14617 1.80036 5.35567 0.0919136 -0.311209 -0.475968 +338 1 8.0974 2.70612 5.29285 -7.26474 -2.41437 5.10983 +339 1 8.1011 1.88391 6.31294 0.0553936 -2.83177 -2.84321 +340 1 7.18351 2.67214 6.17899 0.615225 -0.197791 1.28477 +341 1 8.87232 3.47935 5.28683 2.9021 4.26792 0.541835 +342 1 0.935261 4.37233 5.44726 0.629241 0.918492 -0.917538 +343 1 0.919878 3.52494 6.23281 0.869805 0.127506 1.01894 +344 1 0.00431382 4.37186 6.33532 0.0302966 1.00444 -0.578346 +345 1 1.87251 3.50381 5.42034 -2.4415 2.77086 0.0779929 +346 1 2.70362 4.48406 5.3041 -1.90814 0.882252 2.42793 +347 1 2.75055 3.50273 6.30756 -1.47013 1.25632 -0.795276 +348 1 1.84448 4.4497 6.22456 -0.665656 -0.501499 -0.145372 +349 1 3.61741 3.6732 5.27884 1.4909 -8.59965 8.97662 +350 1 4.55362 4.53069 5.43699 -1.55164 -1.28771 -1.47171 +351 1 4.52256 3.52483 6.1944 -1.86903 1.10409 1.578 +352 1 3.65361 4.51782 6.21866 -3.39722 -3.70857 0.481797 +353 1 5.32088 3.65892 5.41856 2.55855 -1.45769 -1.45685 +354 1 6.25422 4.4123 5.33119 0.406295 0.346858 0.292537 +355 1 6.15978 3.47786 6.34128 0.227911 3.77427 -2.75081 +356 1 5.33342 4.43001 6.30433 -0.582231 -0.0994195 -0.382533 +357 1 7.19473 3.56016 5.44441 -0.898652 0.294925 -2.64663 +358 1 7.98682 4.41046 5.33513 1.4916 0.0945815 1.20731 +359 1 7.97947 3.58929 6.2697 1.92008 -1.0462 0.640867 +360 1 7.19164 4.45465 6.22659 0.298273 0.832684 -0.26134 +361 1 8.91866 5.33922 5.43231 0.972904 -0.678404 -1.89043 +362 1 0.863832 6.24178 5.44793 2.40494 -1.34388 -3.01765 +363 1 0.840212 5.37684 6.26703 1.52144 -3.32025 -2.26664 +364 1 0.0375152 6.17563 6.19921 -3.52547 2.50803 1.96141 +365 1 1.71406 5.31325 5.33193 0.359992 -0.20317 1.05182 +366 1 2.70446 6.22369 5.28953 -1.67496 -0.128385 2.17513 +367 1 2.62094 5.31478 6.20919 0.620292 0.0770975 0.0647467 +368 1 1.78318 6.16446 6.20286 -0.707464 0.30734 -0.850222 +369 1 3.5001 5.34304 5.42111 1.18155 0.33408 -1.88423 +370 1 4.48409 6.21311 5.27474 -6.47906 -0.498054 6.10955 +371 1 4.40434 5.30746 6.24861 3.30032 4.47126 1.95885 +372 1 3.65651 6.23636 6.35732 0.258101 -0.821502 -0.539452 +373 1 5.37686 5.39062 5.45706 -0.495794 0.303868 0.87367 +374 1 6.27665 6.3275 5.44876 0.578726 -4.19567 -0.915026 +375 1 6.28987 5.34918 6.28481 -0.689441 0.646514 -0.025026 +376 1 5.38856 6.30438 6.29204 -0.62461 -0.174266 -0.144794 +377 1 7.10303 5.36134 5.39788 0.303084 -0.453051 0.575398 +378 1 7.97278 6.2689 5.34555 1.29349 -0.0892034 0.239307 +379 1 8.1123 5.2681 6.25774 -0.648694 -0.661016 0.761589 +380 1 7.23419 6.34793 6.22344 -1.98134 -0.75315 1.10815 +381 1 0.0530217 7.08624 5.43675 -2.76329 0.356415 -1.34254 +382 1 0.891502 8.07734 5.33574 -0.449954 -0.433341 -0.0145848 +383 1 0.859902 7.08778 6.21702 1.22817 0.316603 2.39974 +384 1 8.86723 7.96664 6.28254 0.557062 3.16551 -3.15026 +385 1 1.77928 7.05564 5.34292 -1.2854 -0.797113 0.726349 +386 1 2.74792 8.05162 5.34603 0.580474 -0.247926 -0.00393627 +387 1 2.61984 7.13654 6.2076 0.1179 0.00397349 -0.327299 +388 1 1.73531 7.99204 6.32624 -0.619957 1.84241 -1.57732 +389 1 3.59984 7.17613 5.43634 -0.452415 0.706682 -0.14784 +390 1 4.39821 8.05962 5.28157 7.32724 0.749963 7.12774 +391 1 4.53389 7.20586 6.21186 -1.71384 -1.49003 0.809357 +392 1 3.66572 8.09269 6.23368 0.381787 -1.59697 -1.53597 +393 1 5.43811 7.11751 5.40192 -5.5589 -0.00418968 -4.06356 +394 1 6.35445 7.96959 5.31467 -2.59984 2.44569 0.360222 +395 1 6.17375 7.13942 6.18142 5.31103 3.8936 7.8957 +396 1 5.29125 8.02549 6.29493 1.99742 1.43167 0.441829 +397 1 7.11664 7.15874 5.38774 1.63444 -2.12611 -0.430051 +398 1 8.12983 8.0005 5.26693 -0.350623 0.791023 2.07438 +399 1 8.11089 7.10521 6.29529 -1.02761 -0.414645 -0.639575 +400 1 7.1542 8.04467 6.33119 -0.716395 -2.97685 -2.97233 +401 1 0.0455321 0.0581059 7.13785 -2.59331 -3.08955 0.589456 +402 1 0.853998 0.797568 7.23372 2.25232 12.9399 -9.25923 +403 1 0.893883 0.0531987 7.95582 -0.265032 -9.78891 10.4341 +404 1 0.0979374 0.927475 8.08374 -1.27945 -0.625441 0.909779 +405 1 1.70883 0.0184568 7.15475 0.947479 -0.211015 -0.0644084 +406 1 2.65212 0.910749 7.07723 -0.301347 -0.213339 -0.337826 +407 1 2.6305 8.90469 8.0727 2.55272 1.71066 0.384582 +408 1 1.75018 0.91387 8.02574 -0.526684 -0.686186 -0.483147 +409 1 3.61403 8.84934 7.06612 1.02988 1.44024 1.76178 +410 1 4.42034 0.91943 7.17223 0.522178 -1.61468 -2.10925 +411 1 4.37056 0.0516865 8.14003 0.0263315 0.189467 -0.466418 +412 1 3.59 0.934896 8.00045 0.0371044 1.00787 1.05016 +413 1 5.2816 0.0108877 7.14004 0.0410715 -0.366939 -0.311788 +414 1 6.23624 0.898837 7.05965 1.021 0.941131 0.654753 +415 1 6.246 8.87468 8.06175 -0.280098 0.535663 -1.1759 +416 1 5.31648 0.815501 8.12607 -0.78801 0.243527 -0.599256 +417 1 7.10707 8.84874 7.08197 -0.468775 2.08644 1.86713 +418 1 8.05013 0.946529 7.22788 -1.5208 -0.582053 0.186559 +419 1 8.1301 8.84043 8.01457 0.052244 0.715074 -0.282442 +420 1 7.06838 0.987221 8.03414 10.0415 -13.6791 -1.19755 +421 1 8.86835 1.70934 7.22731 2.54892 2.22649 -0.22541 +422 1 0.866325 2.76414 7.15029 -0.0137847 -2.49225 -3.8584 +423 1 0.826708 1.83336 8.03111 1.70357 -1.53255 0.309164 +424 1 0.0511912 2.65175 8.02861 -1.53037 1.53618 -0.152554 +425 1 1.7237 1.71044 7.1133 -0.3904 -0.435435 -0.731182 +426 1 2.66636 2.72018 7.14295 0.547793 -0.274295 0.648117 +427 1 2.70105 1.80209 8.13576 -0.0852062 -0.133841 -0.000493208 +428 1 1.77492 2.76081 8.10399 0.564357 -0.308093 0.985398 +429 1 3.66205 1.87543 7.16799 0.15905 -2.5091 -2.55207 +430 1 4.55348 2.70177 7.05301 -5.50098 -2.53366 3.01389 +431 1 4.46818 1.71608 7.96441 0.32513 1.80226 3.00161 +432 1 3.56091 2.58808 8.02945 0.396266 1.95642 2.12785 +433 1 5.36149 1.84637 7.16969 0.516803 -0.0610583 -0.802699 +434 1 6.28291 2.77184 7.1854 -0.512674 -3.17359 2.22694 +435 1 6.3427 1.71551 7.9726 -15.2061 11.4078 1.6664 +436 1 5.45463 2.61593 8.09933 0.73198 1.12429 -0.810915 +437 1 7.14617 1.80598 7.24022 4.03182 0.503759 -4.81039 +438 1 8.07521 2.6756 7.07092 -0.336894 3.22322 3.478 +439 1 8.11875 1.8373 8.10797 -1.57974 -0.493075 -0.537868 +440 1 7.09714 2.63714 8.02739 -0.0173147 0.820696 1.90431 +441 1 8.85027 3.56499 7.15253 3.00565 -1.27064 -0.682205 +442 1 0.885235 4.38222 7.18774 -1.842 1.22146 -0.226395 +443 1 0.884771 3.48141 7.97536 -0.530218 4.3971 3.23625 +444 1 0.0419078 4.41462 8.04436 -0.806344 -0.262731 -0.956831 +445 1 1.73746 3.66699 7.09267 1.85773 -3.96877 -1.41987 +446 1 2.66489 4.55163 7.19564 0.399017 -1.47837 -0.325749 +447 1 2.68401 3.61278 8.06372 0.262338 -0.0680464 0.329915 +448 1 1.80878 4.38262 7.9551 -1.46544 1.49945 2.09645 +449 1 3.55441 3.63471 7.17184 -0.0924634 0.45212 0.606799 +450 1 4.40759 4.53436 7.23701 0.160045 0.252781 -1.03281 +451 1 4.47938 3.49218 8.04219 0.177099 0.0940276 0.00712601 +452 1 3.55379 4.48752 8.06012 -0.927856 0.341505 -0.0833457 +453 1 5.30335 3.52949 7.1279 2.00125 1.71282 0.0663191 +454 1 6.19233 4.44015 7.09395 -0.123778 -0.82645 0.684973 +455 1 6.31698 3.55227 8.05766 -1.80584 -0.932697 -1.1518 +456 1 5.41804 4.43351 8.09204 -4.30063 -0.218755 -3.96516 +457 1 7.232 3.50321 7.24512 -0.569054 0.129485 -1.05452 +458 1 8.04777 4.39134 7.10023 -0.415559 1.27013 1.1937 +459 1 8.09921 3.54644 7.99275 -0.904288 0.185761 1.62031 +460 1 7.15284 4.38151 8.0646 -0.281528 0.0795406 -1.17401 +461 1 8.85944 5.36104 7.19522 1.71386 -0.372777 -2.67299 +462 1 0.808445 6.15874 7.05432 0.343929 1.70028 2.25424 +463 1 0.99266 5.36055 8.05319 -1.96195 -0.361049 -1.35199 +464 1 8.9228 6.22111 8.03716 -0.328906 0.253391 -0.16959 +465 1 1.7511 5.27554 7.16317 -0.501838 -0.493478 -1.59379 +466 1 2.7323 6.31099 7.08452 0.463177 0.0720173 0.389338 +467 1 2.75106 5.38162 8.09911 0.530948 -0.923774 -0.761524 +468 1 1.80446 6.33727 8.00982 0.567564 -0.353842 0.999402 +469 1 3.53218 5.32026 7.15711 1.3552 1.44822 0.141569 +470 1 4.49512 6.19462 7.20137 -2.95094 2.57244 -4.09211 +471 1 4.4829 5.43783 8.04952 -1.75843 -3.70774 -0.194014 +472 1 3.65767 6.24252 7.97233 -2.18137 -0.334806 -0.189717 +473 1 5.35752 5.46295 7.14871 1.05371 -2.23541 -1.50951 +474 1 6.22804 6.29485 7.12141 -0.370188 0.264704 -0.149428 +475 1 6.34127 5.4593 8.01496 -0.759119 0.239406 -0.0100712 +476 1 5.27101 6.21963 7.98358 4.21356 3.70888 3.53999 +477 1 7.2413 5.39744 7.15422 0.63332 0.408861 0.0765336 +478 1 8.01209 6.33115 7.20214 1.04149 -1.50251 -0.643312 +479 1 8.11155 5.33363 8.02803 -2.08279 1.51127 0.153008 +480 1 7.20203 6.31049 8.06426 -0.105023 -0.935886 0.140492 +481 1 8.92362 7.24394 7.10015 0.0792153 -3.18157 4.09933 +482 1 0.865164 8.02092 7.22606 2.85769 1.65383 -2.61434 +483 1 0.86745 7.15339 8.01815 -0.578541 -0.380635 0.364655 +484 1 0.0284189 8.08161 7.95725 -0.890268 -0.349283 1.10066 +485 1 1.85656 7.22057 7.11535 0.397315 -1.70504 3.16253 +486 1 2.77375 7.96501 7.15423 0.0953595 0.0574297 -0.272157 +487 1 2.64437 7.22314 8.11966 1.48696 -0.179689 -2.12782 +488 1 1.85941 8.11413 7.96635 -2.35368 -2.50728 -0.754549 +489 1 3.67468 7.10829 7.12824 0.65987 0.70298 0.656082 +490 1 4.46621 7.99739 7.2078 2.25404 -0.456947 -2.59682 +491 1 4.48001 7.09955 8.01357 0.0334801 0.324585 -0.290932 +492 1 3.6378 8.02597 7.95299 -1.96867 -0.619231 2.20677 +493 1 5.31589 7.17259 7.15585 0.23145 -0.930936 -0.437425 +494 1 6.20936 8.03122 7.09513 -0.13604 -0.296447 0.152582 +495 1 6.17543 7.22187 8.09898 5.44884 -7.61495 -1.62058 +496 1 5.43883 7.98222 8.0181 -6.37262 6.00913 -1.00537 +497 1 7.14576 7.09705 7.14015 0.407174 1.49093 0.0363952 +498 1 8.02588 8.07609 7.1284 1.43118 -1.40285 -0.689018 +499 1 7.99317 7.15919 8.00286 1.19218 0.601266 0.682892 +500 1 7.2435 8.04597 7.97482 -1.89044 -0.246287 0.1524 +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +500 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 8.5498797333834844e+00 +0.0000000000000000e+00 8.5498797333834844e+00 +0.0000000000000000e+00 8.5498797333834844e+00 +ITEM: ATOMS id type x y z f_1[1] f_1[2] f_1[3] +1 1 0.0109462 8.52194 8.48789 1.60777 3.16074 4.93288 +2 1 0.770239 0.886587 0.0775241 5.1148 0.619933 -4.35337 +3 1 0.914855 8.54009 0.795212 -2.54709 2.40671 3.27622 +4 1 8.53949 0.79582 0.824294 -1.87361 -0.316163 2.22706 +5 1 1.68126 8.45058 8.49491 -0.796772 17.9401 13.8601 +6 1 2.49257 0.906431 0.000759221 8.8197 -0.476032 2.96817 +7 1 2.62932 0.0354753 0.888378 -4.43263 -0.45206 -5.76212 +8 1 1.71329 0.913566 0.778252 -3.74188 -4.37189 3.26227 +9 1 3.42175 0.0965993 8.49503 -4.75784 -8.08943 10.1901 +10 1 4.21271 0.889278 8.46971 8.07159 3.26979 7.09905 +11 1 4.30903 0.0721078 0.771319 -2.20196 2.16322 3.01896 +12 1 3.42332 0.912751 0.876126 -1.2014 -0.27869 -2.68959 +13 1 5.04057 8.48132 8.46735 12.114 4.06773 4.60111 +14 1 5.95626 0.830289 0.0884189 2.64036 5.56585 -7.9642 +15 1 5.95178 0.0392781 0.802073 0.496214 -5.11156 5.55524 +16 1 5.1151 0.919125 0.80056 -4.53937 -3.75487 2.57161 +17 1 6.8031 8.46299 8.54479 -1.12262 1.88258 -1.67969 +18 1 7.77702 0.837169 8.46101 -2.81144 0.601723 4.97774 +19 1 7.61766 0.0190488 0.807902 2.02145 -3.01975 -0.996798 +20 1 6.83813 0.841817 0.893784 2.20091 1.15146 -3.46095 +21 1 0.00483518 1.7748 8.45086 3.14001 0.0124508 7.14446 +22 1 0.925315 2.54775 8.47859 -2.14676 3.17757 1.68537 +23 1 0.946475 1.73152 0.932031 -7.90083 -3.0997 -5.49951 +24 1 0.0820864 2.59152 0.95052 -16.5003 -1.1863 -19.4267 +25 1 1.62363 1.68342 8.4651 1.8496 1.86303 2.33818 +26 1 2.56251 2.66233 0.0202936 -6.7309 -4.60627 -0.0436147 +27 1 2.47347 1.71611 0.900003 2.27232 1.93928 0.205074 +28 1 1.66562 2.5538 0.89239 8.29789 -0.0162708 -2.14995 +29 1 3.47808 1.70927 8.49067 -6.21947 -0.00998514 1.91211 +30 1 4.19294 2.51037 0.0787296 16.1199 8.28753 -17.6776 +31 1 4.29711 1.73051 0.787489 0.142042 -5.75402 7.11231 +32 1 3.43681 2.6439 0.75999 -11.309 -9.11906 21.9869 +33 1 5.20599 1.76704 0.0398807 -10.2389 -11.7619 -5.76949 +34 1 5.91436 2.52733 8.51501 10.4145 9.83206 -1.49498 +35 1 5.9033 1.67223 0.919622 10.1161 4.25667 -5.1777 +36 1 5.15205 2.55373 0.788133 -1.76953 2.31199 6.90362 +37 1 6.92232 1.70971 0.0701593 -2.50899 -1.62202 -0.822044 +38 1 7.5955 2.61765 0.0592135 2.55821 0.640647 0.0382532 +39 1 7.74881 1.7729 0.896218 -1.59166 -5.96851 -6.46077 +40 1 6.80231 2.56106 0.910949 5.84287 -4.44794 -4.99646 +41 1 0.028349 3.48236 8.49963 2.5025 -5.04288 3.39467 +42 1 0.836484 4.27887 0.0816773 0.760548 2.93196 -2.43461 +43 1 0.942186 3.3633 0.783926 -3.69777 5.09684 -0.0674025 +44 1 8.51583 4.33027 0.838505 2.60137 -0.826864 1.21094 +45 1 1.65067 3.4812 8.47243 0.730068 -2.57113 1.91442 +46 1 2.5668 4.2649 8.54781 -0.773361 3.29166 6.51609 +47 1 2.51515 3.35935 0.92744 0.397687 12.5391 -13.0985 +48 1 1.73465 4.30243 0.83421 -1.47193 -2.67124 0.923933 +49 1 3.37869 3.37397 0.0291446 3.12688 15.3224 -6.53558 +50 1 4.34738 4.34434 0.00829503 -5.52046 -6.93359 -2.07611 +51 1 4.32411 3.36572 0.836745 -2.16657 1.87946 3.00206 +52 1 3.33524 4.20214 0.9322 3.17725 3.34929 -6.83564 +53 1 5.08499 3.41929 0.036632 4.03928 -2.58738 -4.81317 +54 1 6.04127 4.33974 8.49644 -0.624803 -0.102814 0.982479 +55 1 6.01611 3.33685 0.909561 -5.08671 5.06768 -6.62403 +56 1 5.207 4.2377 0.760733 -1.32975 0.891019 3.81461 +57 1 6.81304 3.47817 0.0178755 -0.843928 -8.06693 -2.50137 +58 1 7.73203 4.2048 0.00740382 -1.99245 1.66716 -1.57857 +59 1 7.78831 3.44874 0.953497 -3.78613 -1.03229 -4.77194 +60 1 6.90781 4.17709 0.825008 -1.46363 4.64194 5.22986 +61 1 8.46845 5.09622 8.47404 12.6898 1.90364 12.9104 +62 1 0.797366 5.93181 8.52222 2.38416 2.33873 2.4531 +63 1 0.806155 5.19524 0.885366 4.86564 -4.44474 -2.27198 +64 1 0.0123025 5.95271 0.830227 -4.90982 1.72838 0.59014 +65 1 1.70825 5.09756 8.50872 2.27411 3.17124 11.7261 +66 1 2.57892 5.99612 8.47434 -1.64581 0.780097 1.78814 +67 1 2.53606 5.08073 0.912891 1.82428 2.12405 0.338003 +68 1 1.76245 6.06361 0.855052 -0.817516 -1.26047 -0.587481 +69 1 3.36815 5.1611 0.0892763 -1.75416 -1.94918 -4.15038 +70 1 4.34388 5.99478 8.53994 -9.12199 -5.82315 -0.643131 +71 1 4.22842 5.14974 0.779802 4.93843 -0.926739 3.98855 +72 1 3.45177 5.94376 0.905424 -5.40353 3.18508 -3.48186 +73 1 5.06545 5.13306 8.4631 8.02458 6.68819 3.23791 +74 1 5.91929 6.01015 8.53548 3.77131 -1.20656 -2.03594 +75 1 5.88805 5.11842 0.816496 5.73582 1.96394 -4.01157 +76 1 5.18785 6.02276 0.820364 -9.36617 -3.77225 -2.84856 +77 1 6.8933 5.1517 8.49766 -1.10898 -0.445881 0.788116 +78 1 7.73242 5.99103 8.48869 1.48322 -7.68495 9.10162 +79 1 7.66553 5.0457 0.7869 0.413505 3.32493 1.60624 +80 1 6.9298 5.9353 0.896867 -3.44217 0.759559 -1.89572 +81 1 0.0757853 6.76414 0.08264 -2.09776 5.63137 -2.35842 +82 1 0.929754 7.68563 0.0937614 -14.24 2.10473 -10.1605 +83 1 0.947372 6.93568 0.898093 -37.7638 -41.2899 -5.14895 +84 1 0.0463649 7.75037 0.902481 -0.259219 -2.38896 -3.08434 +85 1 1.64115 6.89463 8.52754 6.28385 -7.53573 1.49633 +86 1 2.53763 7.75472 8.45351 15.1175 -6.89071 16.4408 +87 1 2.60347 6.88355 0.853331 -4.53589 -3.86491 -4.69681 +88 1 1.61173 7.63221 0.905993 43.7793 33.7511 -1.13346 +89 1 3.3813 6.82692 8.54355 -0.238432 1.95456 2.34043 +90 1 4.24371 7.77989 0.043504 -5.67067 -7.72392 -1.84442 +91 1 4.1828 6.86814 0.818276 1.21815 -0.827933 0.630987 +92 1 3.3368 7.7382 0.923275 7.52639 -2.01137 -4.72269 +93 1 5.071 6.7563 0.010658 5.49209 11.6713 -3.15323 +94 1 5.90188 7.6356 0.0424163 1.86621 0.862931 -1.97936 +95 1 6.03172 6.8673 0.938495 -1.34369 1.09475 -9.39496 +96 1 5.15248 7.77523 0.857214 -2.90101 -1.73408 2.05686 +97 1 6.89959 6.76423 0.01648 -11.1028 0.34724 0.750719 +98 1 7.65506 7.70409 0.0429309 2.74021 -1.34663 -2.67212 +99 1 7.64597 6.8087 0.792436 6.14337 0.285334 5.54838 +100 1 6.81299 7.61529 0.784654 1.50923 3.73377 2.87701 +101 1 0.039157 8.46192 1.76149 -3.85041 1.88762 -2.12951 +102 1 0.799188 0.819633 1.69376 4.21763 0.723161 -3.63495 +103 1 0.763005 0.0408753 2.55669 11.5628 -1.30287 -1.53659 +104 1 0.0652633 0.934891 2.49039 -5.1145 -1.67274 5.33691 +105 1 1.66381 8.45402 1.66249 1.87623 5.22247 1.17986 +106 1 2.503 0.802578 1.65731 0.0918423 3.77669 3.70231 +107 1 2.51579 0.0135642 2.53917 0.463256 0.0266605 -0.815012 +108 1 1.65685 0.926197 2.57259 5.9178 -9.1905 -0.306187 +109 1 3.4242 0.0443963 1.67808 1.33331 -0.794171 2.32841 +110 1 4.23298 0.877511 1.6619 2.15651 0.36791 0.599305 +111 1 4.23114 8.48221 2.59613 0.139704 5.19667 3.26797 +112 1 3.42382 0.825355 2.52764 0.831325 -0.597344 0.750298 +113 1 5.10755 0.098598 1.64667 1.13835 -0.15217 0.418453 +114 1 6.07979 0.861483 1.66377 -9.38879 -3.1028 5.61252 +115 1 6.06362 0.0403691 2.64895 -6.98521 -8.98289 -11.9164 +116 1 5.20913 0.939312 2.59362 -1.28414 -1.16831 -2.67638 +117 1 6.75529 8.52816 1.79359 4.36806 -0.709446 -4.01445 +118 1 7.76101 0.764033 1.62558 -1.73868 3.93794 4.49945 +119 1 7.66206 0.0708021 2.53607 1.47505 -2.32899 1.29594 +120 1 6.92286 0.947435 2.52138 -4.88314 -16.5943 7.22153 +121 1 8.51449 1.72985 1.71942 6.76951 -3.05423 -0.995536 +122 1 0.834691 2.62553 1.61171 16.0236 -0.437826 23.4167 +123 1 0.945534 1.71145 2.53519 -17.6422 5.766 10.6769 +124 1 8.53575 2.60321 2.48391 2.61084 -9.58061 10.2444 +125 1 1.63294 1.72028 1.76938 14.1815 -0.440268 -11.5313 +126 1 2.57682 2.65502 1.67415 2.8611 -15.9615 10.724 +127 1 2.65189 1.65955 2.48962 -4.47742 1.085 2.58429 +128 1 1.79145 2.49644 2.55538 0.0425348 2.96537 1.56716 +129 1 3.45687 1.73281 1.73911 -3.75938 -0.279924 -8.91417 +130 1 4.34908 2.51749 1.7514 -3.12574 5.69408 -7.34516 +131 1 4.21985 1.73239 2.48294 4.56177 -5.44217 8.83153 +132 1 3.39941 2.5984 2.48766 0.0932155 -0.49927 3.02478 +133 1 5.22539 1.80308 1.7328 -5.21779 -2.43895 2.23844 +134 1 6.07426 2.60134 1.71356 -9.82102 -9.11759 6.53349 +135 1 6.06098 1.72463 2.48049 -24.0059 1.32147 25.9525 +136 1 5.04217 2.48583 2.60699 6.13261 3.37855 2.31458 +137 1 6.77443 1.68358 1.80416 26.2694 11.8834 -33.3324 +138 1 7.78345 2.52468 1.65191 -10.0717 7.23238 6.81167 +139 1 7.67217 1.70427 2.51662 7.38759 5.50979 0.483479 +140 1 6.87655 2.54802 2.65887 0.828003 6.30102 -11.6733 +141 1 8.48905 3.38009 1.79052 3.95862 11.358 -4.16794 +142 1 0.904648 4.31805 1.73458 -1.64595 0.0791848 -3.59387 +143 1 0.882159 3.48871 2.5578 -1.47386 -2.40831 0.515883 +144 1 0.0640856 4.36164 2.51005 -1.54232 -2.6948 -1.06039 +145 1 1.78366 3.38548 1.78248 -8.79706 -1.19951 -6.15917 +146 1 2.61647 4.18826 1.75601 -13.6767 13.2656 0.0962066 +147 1 2.49967 3.46972 2.59724 11.287 -7.88562 -0.187146 +148 1 1.72994 4.21494 2.4741 -1.76295 10.5241 6.69302 +149 1 3.35408 3.46945 1.74549 12.0923 -11.3982 2.63093 +150 1 4.33371 4.2573 1.65266 -1.0572 -0.0681575 -0.357999 +151 1 4.25135 3.37501 2.62082 -0.724851 2.23609 -3.08367 +152 1 3.37046 4.34755 2.6064 0.218455 -8.01846 -3.14612 +153 1 5.16664 3.3978 1.80383 -2.26051 -2.46633 -4.30603 +154 1 6.02075 4.21565 1.63908 -0.444656 2.88859 -0.464916 +155 1 6.04443 3.46025 2.46975 -2.50911 -3.21487 7.82311 +156 1 5.06457 4.21348 2.57808 1.01082 5.99339 -2.31274 +157 1 6.80721 3.3694 1.6818 12.0846 7.00158 1.77966 +158 1 7.66426 4.31037 1.75089 1.93845 -1.12426 -1.15071 +159 1 7.67666 3.35746 2.66226 0.0349977 1.35377 -1.51011 +160 1 6.86746 4.18845 2.58559 1.34212 2.76274 1.29577 +161 1 0.0121787 5.21746 1.67805 -1.66136 -3.05338 2.49187 +162 1 0.848043 6.06063 1.634 -1.152 -1.54074 2.03353 +163 1 0.891535 5.1714 2.53903 -1.80088 0.0367987 2.5043 +164 1 8.53141 6.02479 2.48115 1.46529 0.600203 2.28151 +165 1 1.67096 5.18637 1.75513 2.90335 -0.353263 -4.03581 +166 1 2.63344 6.0279 1.70432 -16.3644 -8.57778 -6.55322 +167 1 2.48532 5.10477 2.59913 0.462017 -0.718364 -1.79537 +168 1 1.74617 5.95248 2.59859 0.0442724 3.34654 -0.327538 +169 1 3.3871 5.11741 1.76498 -0.70902 0.100622 -1.55997 +170 1 4.23897 5.91622 1.65627 3.82091 1.24022 3.5679 +171 1 4.18272 5.19526 2.64844 4.07887 -0.154168 -2.99301 +172 1 3.33243 6.04257 2.48749 13.2178 -9.29314 8.76503 +173 1 5.21355 5.13048 1.6694 -5.38913 -0.724028 1.81762 +174 1 5.88731 6.04999 1.61164 27.08 -23.484 7.87668 +175 1 5.91685 5.19555 2.55373 8.22272 -5.32197 -1.91553 +176 1 5.22513 6.01752 2.48789 -6.37641 3.03262 4.81469 +177 1 6.87923 5.14396 1.75241 -1.31228 -0.52571 -0.175031 +178 1 7.66325 6.00346 1.75398 1.55065 0.721262 -1.56625 +179 1 7.71088 5.21107 2.64045 -0.197441 -3.63935 -3.47269 +180 1 6.81367 6.03163 2.50271 -0.887486 -5.65654 8.47366 +181 1 8.45469 6.86312 1.68381 5.32955 -1.93357 -1.0964 +182 1 0.887234 7.64699 1.70441 -8.03342 4.67955 6.65869 +183 1 0.827773 6.84361 2.49826 0.666014 -0.927683 2.41577 +184 1 0.0243326 7.6531 2.64337 -2.41729 -1.59288 -7.26092 +185 1 1.67566 6.82407 1.70759 6.3287 0.149047 4.42322 +186 1 2.51454 7.65687 1.63227 -3.24159 2.2536 7.24906 +187 1 2.61047 6.80534 2.59521 -8.48569 7.62473 -2.75927 +188 1 1.62469 7.75189 2.55083 1.70283 -3.32336 -0.400725 +189 1 3.32845 6.81114 1.68061 10.3844 9.25335 0.5217 +190 1 4.35781 7.7751 1.79868 -7.49989 -3.23754 -13.7369 +191 1 4.19243 6.92819 2.60428 15.2501 -13.591 -1.36339 +192 1 3.43706 7.60555 2.52571 -13.7857 14.6138 -0.968483 +193 1 5.20185 6.77695 1.66316 -21.9331 19.6829 3.32007 +194 1 5.90138 7.62608 1.77842 3.59956 5.50204 -2.20333 +195 1 5.95566 6.93899 2.64467 1.5684 -14.0837 -9.48217 +196 1 5.06902 7.62841 2.55428 6.74225 1.46675 8.63059 +197 1 6.76742 6.8085 1.78801 1.36869 6.36826 -6.59728 +198 1 7.65843 7.62584 1.68675 -2.22178 4.8322 -2.62428 +199 1 7.67415 6.89867 2.52463 2.21143 -5.15334 3.5596 +200 1 6.87662 7.66202 2.55284 -3.26152 2.73313 1.32325 +201 1 0.0405641 8.51038 3.32948 -5.92557 3.54592 8.59039 +202 1 0.809165 0.908392 3.38948 1.71953 -1.70344 0.923667 +203 1 0.901714 8.46653 4.19384 -9.71216 4.93867 8.34322 +204 1 0.069999 0.928448 4.31429 -4.27362 -2.53344 -6.14786 +205 1 1.6264 8.4509 3.42354 8.98155 6.03203 -6.76996 +206 1 2.65602 0.762944 3.43842 -5.54094 5.64927 -11.0802 +207 1 2.61793 0.0468587 4.22961 -1.55064 -6.54911 6.6458 +208 1 1.68094 0.888048 4.32275 0.711784 -4.72688 -3.71581 +209 1 3.43429 8.45723 3.40115 7.64008 12.4108 0.619842 +210 1 4.23416 0.880739 3.42582 5.39503 -6.32873 -0.402512 +211 1 4.18642 8.4609 4.33191 11.6244 16.7018 2.29066 +212 1 3.36155 0.898574 4.22656 4.93072 -1.64922 5.55995 +213 1 5.13206 0.0787666 3.45034 -0.945527 -3.11163 -2.8253 +214 1 6.05542 0.815095 3.33818 0.680768 11.3265 10.7561 +215 1 5.88615 0.068379 4.32153 11.9175 -9.57172 -8.45948 +216 1 5.21525 0.885851 4.19789 -5.15816 5.54694 4.34946 +217 1 6.80589 8.45257 3.40423 5.88256 0.0541198 6.21084 +218 1 7.74454 0.870555 3.46229 0.501904 -4.05279 -5.44709 +219 1 7.62711 0.0144156 4.35804 1.95636 -0.757148 -6.431 +220 1 6.7475 0.756319 4.34542 2.82117 3.60456 -0.442947 +221 1 0.046471 1.74765 3.48426 -2.94726 0.460616 -2.28233 +222 1 0.888532 2.54472 3.37968 0.966992 1.17998 0.546373 +223 1 0.832134 1.79852 4.28422 5.1168 -14.8036 -11.8055 +224 1 0.0855384 2.60849 4.37243 -9.37894 3.13224 -11.0091 +225 1 1.76053 1.64213 3.45381 -3.40447 2.71972 -2.85028 +226 1 2.52635 2.61582 3.43297 3.65437 -1.51294 -3.08517 +227 1 2.50122 1.75788 4.25552 8.72555 -0.689386 -1.86072 +228 1 1.75205 2.6278 4.21833 -8.89154 -5.54607 2.69229 +229 1 3.50205 1.65486 3.36684 -7.50491 6.39615 -0.836562 +230 1 4.28152 2.60594 3.4252 -1.76945 -2.76432 2.53661 +231 1 4.17705 1.67239 4.28707 6.76533 -1.25356 -1.29705 +232 1 3.44438 2.47178 4.25656 -4.81944 5.002 -0.576402 +233 1 5.22486 1.68937 3.43619 -3.28026 2.78772 -4.39101 +234 1 6.02069 2.55292 3.33778 -3.72236 0.507942 3.01424 +235 1 5.96152 1.77008 4.23889 4.98563 -0.248026 3.40967 +236 1 5.17107 2.61009 4.24734 -0.598251 0.473097 -0.376582 +237 1 6.87337 1.72985 3.32607 -2.78397 -6.76638 7.83701 +238 1 7.692 2.50127 3.44714 2.52098 2.71173 -0.194497 +239 1 7.63531 1.64894 4.19535 0.881487 3.19892 6.53537 +240 1 6.92924 2.5559 4.32195 -3.68781 1.74243 -2.92343 +241 1 0.0154582 3.42553 3.38818 0.573657 0.250438 1.11994 +242 1 0.946668 4.34133 3.49534 -14.1263 -16.7645 -9.90419 +243 1 0.911751 3.43019 4.31621 -0.850264 0.755291 -1.68921 +244 1 0.0046042 4.25775 4.34424 -1.31738 -1.24756 -1.54253 +245 1 1.76086 3.48229 3.3966 -12.418 -8.98763 3.21891 +246 1 2.48605 4.22978 3.40508 14.0841 10.3397 -4.15997 +247 1 2.54799 3.33831 4.30225 4.92033 13.8543 -7.00111 +248 1 1.7676 4.3622 4.17566 0.280546 -16.6448 26.3844 +249 1 3.37038 3.45998 3.42173 -0.200746 -1.45028 -1.29578 +250 1 4.20874 4.30541 3.50172 4.65367 -11.48 -19.1828 +251 1 4.21154 3.43635 4.23457 4.19917 -3.40534 2.03948 +252 1 3.45806 4.23712 4.25878 -8.55751 2.75292 6.08306 +253 1 5.11168 3.47839 3.3691 -0.311412 -5.69502 5.70804 +254 1 5.92148 4.26406 3.41002 5.13821 -1.04796 0.0327238 +255 1 6.02264 3.46008 4.23226 -3.02748 -3.55814 1.41554 +256 1 5.17114 4.24863 4.35423 -2.77791 4.93248 -13.0008 +257 1 6.86557 3.34851 3.50434 -4.54964 -0.0741147 -9.06001 +258 1 7.67607 4.29403 3.50495 4.02814 6.65377 -10.7943 +259 1 7.67432 3.49417 4.17544 8.6417 -11.3672 14.2425 +260 1 6.8466 4.22166 4.23144 -3.46256 4.46394 4.938 +261 1 0.0814499 5.05812 3.37338 -2.94602 3.43381 2.0972 +262 1 0.952662 5.9924 3.43554 -2.60446 0.4469 0.54362 +263 1 0.765082 5.07607 4.26673 5.31334 4.0071 5.5605 +264 1 0.0672914 5.95184 4.29838 -1.77164 3.23629 -2.96482 +265 1 1.64676 5.09677 3.49021 9.45599 25.7387 -15.7709 +266 1 2.59524 6.06011 3.441 -1.69946 -11.0916 -4.14222 +267 1 2.46878 5.21999 4.3176 5.41184 -22.6386 -22.4739 +268 1 1.72435 5.99765 4.33067 -8.961 3.18884 -2.81076 +269 1 3.33576 5.13502 3.32819 -1.95672 4.97188 10.3591 +270 1 4.33219 6.01601 3.4905 -3.43576 -1.4684 -1.43775 +271 1 4.2868 5.05318 4.19611 2.54498 12.874 12.0539 +272 1 3.47487 5.92769 4.31716 -1.095 0.823289 -0.856965 +273 1 5.22135 5.10776 3.40172 -8.93936 2.06172 1.30023 +274 1 6.0405 5.92456 3.43523 0.724841 2.24513 0.144002 +275 1 5.92006 5.1314 4.26005 8.25611 -3.42587 -2.20917 +276 1 5.11155 5.91401 4.29084 1.00396 1.28478 -0.181662 +277 1 6.86476 5.07118 3.47111 -5.70253 1.83988 -3.65428 +278 1 7.60709 5.97166 3.43329 1.57958 3.02153 1.22094 +279 1 7.62121 5.17116 4.25108 13.415 -9.76593 -1.32536 +280 1 6.90725 5.93696 4.35438 -12.0061 10.5099 -5.89092 +281 1 0.0158532 6.88433 3.5005 2.50125 -3.66413 -3.15884 +282 1 0.832759 7.6858 3.39159 0.810583 -3.83454 1.16734 +283 1 0.879361 6.87893 4.25184 1.06811 -4.80567 -3.71366 +284 1 8.48025 7.67569 4.32838 6.71448 4.3067 1.89144 +285 1 1.76699 6.83608 3.37875 -3.92913 2.06189 -0.762911 +286 1 2.64337 7.79272 3.38564 -11.5742 -11.6301 0.504133 +287 1 2.51611 6.79594 4.20547 2.9771 6.7763 8.40555 +288 1 1.73472 7.75634 4.30153 3.5376 -4.65751 1.06495 +289 1 3.42458 6.78486 3.36363 0.711862 2.92454 6.30952 +290 1 4.29146 7.78029 3.51531 3.92856 -8.43358 -6.61451 +291 1 4.22796 6.89496 4.356 2.49253 -3.58746 -4.19183 +292 1 3.49073 7.69895 4.31251 -15.4332 -7.21194 0.0843114 +293 1 5.03295 6.88949 3.43613 2.4132 0.715094 1.20127 +294 1 5.9914 7.60738 3.43115 0.166605 10.2994 10.8333 +295 1 6.06057 6.76316 4.28526 -0.682389 0.774521 0.518315 +296 1 5.1506 7.68481 4.35956 -0.587179 -0.831286 -4.17718 +297 1 6.91829 6.87557 3.41173 -2.20287 0.087574 0.74732 +298 1 7.77376 7.66664 3.47631 -5.20912 2.94829 -3.10686 +299 1 7.7733 6.85147 4.2793 -6.28798 -5.26886 2.97867 +300 1 6.79627 7.70864 4.34123 1.13479 0.471756 -2.41754 +301 1 8.47537 0.0666715 5.07785 3.07732 -2.35936 2.36099 +302 1 0.837862 0.824189 5.08442 2.67015 -0.0526079 4.2528 +303 1 0.947354 8.53746 5.97515 -9.44477 -2.06512 3.38353 +304 1 8.45527 0.903487 5.90211 4.35699 -8.49334 13.6006 +305 1 1.71466 0.0614796 5.21675 1.71751 -10.7388 -14.8483 +306 1 2.56545 0.785351 5.1483 1.0332 2.19745 -1.75997 +307 1 2.58448 8.48208 5.91956 0.430753 0.76971 3.58164 +308 1 1.65003 0.816215 5.93197 3.03102 12.7849 8.36083 +309 1 3.46033 0.0141985 5.16494 -4.25366 -0.783326 -0.484155 +310 1 4.20213 0.929517 5.13838 2.42665 -3.78185 -0.152962 +311 1 4.26733 0.0836521 5.92638 3.25998 -1.091 1.74874 +312 1 3.41102 0.861262 6.03148 -0.949591 0.0559607 -1.66554 +313 1 5.1564 8.53616 5.06672 -11.5945 -0.673098 9.37255 +314 1 5.94115 0.761043 5.20173 4.62182 33.122 -29.3364 +315 1 5.93463 0.0696556 5.8868 1.75697 -30.8547 30.3151 +316 1 5.14065 0.9256 5.95741 -0.006185 -4.789 2.4932 +317 1 6.91953 8.50208 5.18386 -10.6338 4.52372 2.129 +318 1 7.72317 0.898909 5.10883 -6.55365 -0.206627 -4.30053 +319 1 7.67728 0.0288812 5.99182 2.50541 0.776267 0.642418 +320 1 6.91834 0.891409 5.91811 -4.13582 -0.84176 -0.41985 +321 1 0.0355634 1.62397 5.15959 0.786537 13.0999 -7.10363 +322 1 0.855042 2.4658 5.05819 10.8208 10.8619 21.426 +323 1 0.798893 1.71459 6.01685 5.79471 -4.43182 -0.915803 +324 1 0.0659206 2.49237 5.91102 -5.57064 6.4328 0.916789 +325 1 1.77633 1.69788 5.04117 -5.55508 3.43302 7.46453 +326 1 2.55086 2.64298 5.08873 0.0193134 -8.77259 6.85672 +327 1 2.49765 1.63315 5.92814 1.12021 1.50275 1.88199 +328 1 1.80539 2.621 5.95731 -6.21714 -3.35524 -0.269961 +329 1 3.34329 1.63256 5.07699 -2.20219 4.06192 2.43743 +330 1 4.31458 2.52073 5.06335 -0.0632538 1.3392 1.20942 +331 1 4.33916 1.68863 5.97126 -3.41941 3.44417 2.01134 +332 1 3.42212 2.64548 5.89276 -0.0280586 -2.67425 3.44656 +333 1 5.16333 1.72803 5.18363 0.62931 0.268233 -3.53629 +334 1 5.97493 2.53755 5.18126 5.42417 -2.99996 -10.5798 +335 1 5.97644 1.77632 6.05208 2.30795 -0.932212 -2.38345 +336 1 5.20771 2.64035 5.9206 -9.19429 -1.91265 5.67918 +337 1 6.82113 1.7288 5.07227 0.319047 -2.27809 2.42075 +338 1 7.76584 2.66005 5.04767 0.36372 -2.98667 3.98468 +339 1 7.68048 1.73285 5.98682 1.83082 2.55026 -3.35109 +340 1 6.77723 2.66049 6.0628 11.9195 -28.0419 -0.192401 +341 1 8.52926 3.48894 5.20725 0.756027 -4.20422 -2.12394 +342 1 0.880496 4.18659 5.21886 -2.21024 5.88812 -5.98946 +343 1 0.823278 3.46696 6.03218 3.03891 -2.5906 1.31712 +344 1 8.45604 4.28238 5.97679 3.43734 -0.298701 2.3281 +345 1 1.66848 3.43018 5.1681 4.45896 -2.65722 -0.776378 +346 1 2.47623 4.29797 5.21376 10.0204 -9.1421 -8.64412 +347 1 2.46945 3.49538 6.0664 15.3766 -12.245 -4.5397 +348 1 1.75883 4.22715 6.00615 -17.7933 12.7993 4.23364 +349 1 3.32535 3.48763 5.18919 1.16348 3.11251 -2.54898 +350 1 4.29953 4.30461 5.21296 -7.48003 6.57243 -13.8987 +351 1 4.32836 3.50006 5.90127 -9.25916 -18.9556 4.88449 +352 1 3.45987 4.23872 6.06433 -4.26661 1.09432 -3.11516 +353 1 5.16317 3.46797 5.05136 -2.20358 -10.3645 8.38524 +354 1 6.01128 4.18674 5.11415 3.72823 2.851 1.21774 +355 1 6.05124 3.32995 5.89897 -17.0823 24.7049 3.10753 +356 1 5.05098 4.23901 5.94533 18.4684 10.5132 6.34816 +357 1 6.93195 3.37363 5.21832 -12.1973 3.61502 -16.8233 +358 1 7.67472 4.24466 5.1448 -0.046387 1.44369 -2.14451 +359 1 7.59877 3.3598 5.99617 16.3705 11.4653 3.48987 +360 1 6.9163 4.33093 6.01136 -0.884888 -0.827495 0.436994 +361 1 8.47485 5.1618 5.06757 4.58611 -6.95556 3.64111 +362 1 0.866551 5.92561 5.22826 -2.4458 0.731452 -4.83922 +363 1 0.856029 5.03088 5.93872 -0.961264 1.16585 2.50638 +364 1 0.025531 6.08363 6.03301 -0.603503 -3.86392 0.433571 +365 1 1.73882 5.05771 5.16436 -7.87894 6.49017 -0.085231 +366 1 2.54586 5.89415 5.04217 4.79689 21.4637 24.3945 +367 1 2.63875 5.11717 5.9033 -10.4096 0.222879 12.4433 +368 1 1.7282 6.02787 5.89482 3.82714 -3.17245 6.07309 +369 1 3.41343 5.11888 5.19776 7.89672 -3.25441 -9.4893 +370 1 4.34849 6.08405 5.13729 -6.43313 -7.37614 1.57014 +371 1 4.30919 5.18003 6.06007 -0.523489 -1.53897 -0.492658 +372 1 3.32135 5.97978 5.88753 6.80953 0.93257 3.29984 +373 1 5.2281 5.04347 5.09516 -5.81719 1.07839 6.76004 +374 1 5.94602 5.8851 5.09539 3.02249 4.44225 2.10278 +375 1 6.04092 5.17575 6.07061 0.50428 -9.39491 -12.3653 +376 1 5.21437 6.06631 6.06016 -6.35945 -8.11006 -13.4627 +377 1 6.91579 5.12007 5.08308 -5.11836 -4.49572 6.409 +378 1 7.70983 5.91053 5.07808 1.5309 9.32926 6.58643 +379 1 7.76683 5.15653 6.01534 -1.66429 -5.18049 -8.59085 +380 1 6.93784 6.03915 5.96221 -25.2768 -19.3137 -6.75792 +381 1 0.0625638 6.74931 5.10819 -0.676634 2.54846 -0.0250987 +382 1 0.86361 7.61298 5.03345 -2.5044 7.0388 6.38474 +383 1 0.851706 6.88156 6.03092 0.201379 -3.97494 -1.33706 +384 1 0.0506067 7.6425 5.89338 -1.769 2.22377 0.622415 +385 1 1.66322 6.86583 5.19561 3.09287 -3.33398 -7.05581 +386 1 2.62799 7.62451 5.17609 -27.9662 28.0267 -4.59006 +387 1 2.66202 6.83135 5.96842 -24.8289 -0.817724 19.495 +388 1 1.64735 7.66733 5.92394 4.49398 5.54382 1.70924 +389 1 3.32274 6.93842 5.22499 45.6897 -26.2601 -20.0997 +390 1 4.28266 7.68312 5.1494 -0.162983 0.307259 3.3477 +391 1 4.21122 6.74188 6.04596 -0.795282 5.66715 -3.63702 +392 1 3.40786 7.67271 6.05784 2.18013 1.35082 -0.335047 +393 1 5.13386 6.80127 5.05013 6.80473 4.27889 3.23937 +394 1 6.0188 7.62146 5.18796 -3.27693 10.2601 -11.1928 +395 1 5.9142 6.93974 5.96821 7.16288 -22.7812 5.828 +396 1 5.1207 7.60724 5.96887 -13.0365 8.36981 -2.80723 +397 1 6.90344 6.91817 5.14994 -0.204819 -5.34708 -0.858742 +398 1 7.6747 7.73724 5.15589 4.74286 -4.17129 0.509029 +399 1 7.64232 6.7419 6.03772 18.4896 23.5989 -0.89996 +400 1 6.75496 7.62762 6.01659 7.03025 5.11039 1.24431 +401 1 0.0963896 0.0201086 6.80553 -1.40648 -0.449972 0.0493894 +402 1 0.835843 0.891839 6.79877 7.20248 -7.32555 0.745706 +403 1 0.918901 8.53581 7.64787 -17.0565 2.54879 17.4592 +404 1 0.0577403 0.896342 7.73471 1.30728 -4.31515 -1.61795 +405 1 1.61051 8.45024 6.92242 29.7484 14.9171 -14.6755 +406 1 2.47578 0.885204 6.88627 1.39053 -1.86497 -2.40181 +407 1 2.50444 0.0274811 7.76899 5.04636 2.83552 -7.66004 +408 1 1.76075 0.832954 7.77629 -9.26653 -0.311946 -7.26081 +409 1 3.50837 8.51457 6.78791 -7.98313 -6.7176 0.868776 +410 1 4.17648 0.757665 6.93195 8.57719 11.9693 -2.56623 +411 1 4.23832 0.0657272 7.77237 -2.00114 -7.83956 -8.62893 +412 1 3.37339 0.86481 7.76894 -4.57993 4.49098 -10.8865 +413 1 5.14407 0.0592801 6.76072 -1.57797 -1.16589 1.03837 +414 1 5.93853 0.879814 6.88423 6.63031 -4.29327 -1.40131 +415 1 6.03919 8.48714 7.63222 -2.96915 1.1039 1.2166 +416 1 5.15255 0.794385 7.73799 -0.425319 2.1861 -1.28188 +417 1 6.89313 0.0918814 6.89086 -1.49841 -3.77335 -3.98868 +418 1 7.61212 0.939213 6.80354 8.77263 -4.1407 2.30253 +419 1 7.70899 8.53849 7.72172 -1.01623 -1.03696 -1.75272 +420 1 6.83169 0.853131 7.69229 0.514071 1.96118 2.47006 +421 1 0.0995377 1.63996 6.92907 -20.9698 6.48021 -16.3567 +422 1 0.856061 2.59196 6.8009 3.6314 -4.45866 -1.95318 +423 1 0.7986 1.79168 7.64825 21.262 -5.45904 12.6361 +424 1 0.086833 2.5674 7.63497 -11.6486 2.30739 1.5806 +425 1 1.65946 1.72494 6.90853 -2.96091 -3.71884 -7.8878 +426 1 2.55175 2.62076 6.77199 1.34599 -1.3093 4.14575 +427 1 2.49264 1.73911 7.61263 5.68035 -0.198489 5.50404 +428 1 1.73023 2.55227 7.60126 -2.61513 6.16936 5.4644 +429 1 3.34887 1.7831 6.78557 0.7181 -0.718938 0.35045 +430 1 4.23104 2.60662 6.78869 6.67274 -5.2978 -0.800832 +431 1 4.35855 1.74494 7.60411 -4.34125 -3.35913 2.62052 +432 1 3.36542 2.60589 7.78048 1.27821 -1.57097 -4.57229 +433 1 5.20004 1.65594 6.83168 -6.03666 5.50106 2.07188 +434 1 5.95504 2.56783 6.93549 0.704503 2.20695 -11.5481 +435 1 6.05448 1.73837 7.6627 -1.83376 -2.83098 2.15288 +436 1 5.1146 2.5438 7.6124 2.3372 -0.290906 4.36925 +437 1 6.88113 1.721 6.77631 -7.16431 5.43568 2.84999 +438 1 7.667 2.62761 6.74793 2.83097 -7.51196 9.4855 +439 1 7.73348 1.72515 7.754 -4.1563 0.657477 -6.03723 +440 1 6.7624 2.63316 7.64937 6.65302 -0.565372 4.94425 +441 1 0.0849859 3.37793 6.84942 -10.0386 4.11872 -3.53604 +442 1 0.857904 4.2895 6.93068 1.24699 0.504054 -2.41984 +443 1 0.822866 3.35005 7.62376 7.62204 5.76535 8.89189 +444 1 0.0609986 4.27823 7.72873 -1.62474 0.278416 -2.41968 +445 1 1.65771 3.45598 6.89789 2.67743 0.0202624 -2.34558 +446 1 2.54508 4.23374 6.86348 0.989961 3.94158 3.39783 +447 1 2.51344 3.50821 7.77131 2.79285 -8.19104 -6.06353 +448 1 1.76675 4.31871 7.74484 -7.62178 -3.47349 -5.94274 +449 1 3.46999 3.3444 6.87805 -6.49672 7.19856 -0.129806 +450 1 4.27761 4.20284 6.7963 2.00695 2.57497 4.55692 +451 1 4.36643 3.33193 7.71738 -5.18938 3.59254 -0.980407 +452 1 3.39117 4.21736 7.78484 2.56803 1.85612 -2.81745 +453 1 5.17851 3.50703 6.80054 -0.562057 -4.69817 1.35476 +454 1 5.91855 4.34694 6.82856 20.1656 -16.4219 -1.68121 +455 1 5.94421 3.41917 7.73472 -0.686701 1.44481 -0.413888 +456 1 5.21752 4.35256 7.70192 -2.57704 -7.73472 4.05334 +457 1 6.81349 3.41173 6.82265 -1.40277 6.3135 5.01717 +458 1 7.75813 4.35693 6.90395 -1.64702 -1.61669 -0.476323 +459 1 7.7614 3.35066 7.72289 -1.59004 1.58238 -2.0122 +460 1 6.90386 4.19648 7.73719 0.143217 3.47184 -3.3084 +461 1 8.51568 5.21538 6.91302 4.27065 -2.85002 -1.50895 +462 1 0.951652 6.01174 6.9207 -11.7991 -7.13131 -18.8927 +463 1 0.936182 5.16144 7.77632 -7.30596 -5.41004 -9.74737 +464 1 0.00163562 6.07485 7.63199 0.624183 -4.07361 5.99132 +465 1 1.66533 5.15284 6.74597 2.96466 -1.56742 2.06772 +466 1 2.61909 5.93515 6.89385 -1.40662 1.18192 -1.24787 +467 1 2.46927 5.13962 7.72554 6.76967 2.2802 -3.81441 +468 1 1.64453 6.02831 7.68681 19.7677 -7.24739 11.5441 +469 1 3.40343 5.06011 6.8889 -0.198511 0.401262 -0.796323 +470 1 4.30752 6.01937 6.85588 -10.789 -11.9311 3.49788 +471 1 4.28416 5.14222 7.62835 0.609452 -0.263512 0.8346 +472 1 3.47645 6.07368 7.70428 -7.22384 -10.7657 -0.906726 +473 1 5.22078 5.0656 6.90915 -18.0053 20.6161 -6.39 +474 1 5.99499 5.93089 6.77083 3.48021 13.0571 15.6598 +475 1 6.05342 5.21794 7.69617 -5.52282 -4.0969 2.40523 +476 1 5.15908 5.93838 7.59985 0.288818 1.34614 5.01043 +477 1 6.82844 5.21514 6.92244 2.6589 -10.3439 -6.80084 +478 1 7.65444 5.90306 6.73997 5.39846 9.09532 17.1635 +479 1 7.73871 5.1328 7.74827 -11.0217 0.411956 -11.9718 +480 1 6.85057 5.9849 7.66627 -2.19779 2.18231 4.19621 +481 1 8.49223 6.85953 6.88515 0.63092 3.61848 -3.8326 +482 1 0.912061 7.72558 6.80554 -14.7372 -15.0451 -0.530208 +483 1 0.94972 6.80465 7.60047 -8.86666 17.9559 7.11774 +484 1 0.0485157 7.69847 7.76952 0.871021 -3.29928 -3.01128 +485 1 1.7395 6.92207 6.74618 -0.216972 -4.99493 2.92958 +486 1 2.48517 7.73307 6.85664 4.02861 0.442708 -0.186237 +487 1 2.60224 6.86957 7.70226 -2.68029 -0.280597 -1.3011 +488 1 1.75659 7.71058 7.78997 -12.217 -12.015 -24.8657 +489 1 3.36601 6.81921 6.83807 2.83617 1.11452 1.50668 +490 1 4.30578 7.6333 6.9198 -11.3388 0.787746 -11.6868 +491 1 4.17656 6.84912 7.75346 9.62737 7.65922 -1.79281 +492 1 3.37828 7.72239 7.62462 0.544776 0.263736 1.68806 +493 1 5.03666 6.75188 6.83201 10.5371 18.8221 7.02157 +494 1 5.88561 7.69892 6.74579 2.44744 2.75196 7.83 +495 1 6.02886 6.89217 7.71335 -1.94107 -2.07696 0.28038 +496 1 5.05253 7.6432 7.63466 10.7152 0.484071 10.517 +497 1 6.76592 6.82276 6.85512 1.71624 -1.12004 -2.46021 +498 1 7.63682 7.73046 6.77254 1.37903 -1.27982 -0.239663 +499 1 7.60482 6.74157 7.76697 8.04118 12.5638 -12.9988 +500 1 6.86424 7.69163 7.60229 0.0588858 0.119654 2.66424 +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +500 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 8.2207069144348992e+00 +0.0000000000000000e+00 8.2207069144348992e+00 +0.0000000000000000e+00 8.2207069144348992e+00 +ITEM: ATOMS id type x y z f_1[1] f_1[2] f_1[3] +1 1 0.0109462 8.19276 8.15872 -2.39444 9.6729 7.55614 +2 1 0.913757 0.79291 0.0997863 -14.8553 6.06953 -19.2131 +3 1 0.922041 0.00329478 0.797424 -4.57303 -13.0314 3.29774 +4 1 0.0667547 0.768895 0.898382 -4.60646 8.57627 -8.38591 +5 1 1.74036 8.13245 0.0766359 -17.8989 17.5469 -5.09772 +6 1 2.47269 0.889925 0.0248853 -5.42566 -21.0007 -17.6291 +7 1 2.46322 8.1233 0.872599 4.75898 11.1097 -4.77186 +8 1 1.65846 0.837491 0.791152 15.1363 -5.40511 14.9864 +9 1 3.32881 8.19546 0.053156 -13.3342 -9.93994 -9.94684 +10 1 4.03279 0.760382 0.00184897 9.91793 7.67217 -5.53917 +11 1 4.13378 8.169 0.732239 -0.574085 -2.22965 11.4349 +12 1 3.20922 0.774467 0.746193 11.6707 -5.4973 20.7036 +13 1 4.84922 8.194 8.14339 7.30804 6.79019 8.16024 +14 1 5.8218 0.772541 8.17358 -10.0231 -1.2549 7.34514 +15 1 5.68256 8.16785 0.77714 3.02512 1.45358 -0.272422 +16 1 4.85759 0.84201 0.746179 4.61671 -0.701957 -1.77598 +17 1 6.62546 8.16087 8.21828 -7.1959 6.90651 13.7327 +18 1 7.47259 0.88807 0.0569708 -4.40901 -2.93179 -3.05075 +19 1 7.47431 0.0411346 0.771198 -11.1102 -3.58532 -4.76152 +20 1 6.57656 0.847149 0.913044 26.339 -17.4997 -36.7448 +21 1 8.18759 1.70398 8.18761 4.1072 -0.492398 0.811998 +22 1 0.899666 2.41042 8.17073 -11.5274 -4.75425 3.68191 +23 1 0.850302 1.72005 0.839978 5.34352 -14.6759 -1.78579 +24 1 0.0603398 2.39798 0.844681 -8.60658 17.5352 -6.64359 +25 1 1.71223 1.59237 0.0242378 -11.0164 14.7761 -6.28233 +26 1 2.39934 2.5183 0.00540478 8.02997 -3.83137 6.03634 +27 1 2.48112 1.56604 0.834626 2.61805 16.1266 0.364368 +28 1 1.6143 2.50502 0.831093 22.9512 -23.9291 -18.4162 +29 1 3.30714 1.5456 0.0352888 3.02185 20.9324 -4.02492 +30 1 4.17998 2.44319 8.21567 -15.5858 -1.30182 -5.2994 +31 1 4.13571 1.72982 0.900024 -11.4398 -17.9409 -9.12775 +32 1 3.31093 2.54257 0.820203 -10.3368 -11.5392 -3.6507 +33 1 5.0044 1.71067 8.16991 -2.52586 -20.2729 12.2321 +34 1 5.83707 2.42978 0.0552544 -9.07217 4.33101 -1.43054 +35 1 5.68958 1.61323 0.87339 20.6627 3.79367 -24.2404 +36 1 4.88712 2.41203 0.783075 18.227 14.4306 8.63131 +37 1 6.51234 1.55641 0.0925838 9.00513 9.77167 -3.15357 +38 1 7.38894 2.55021 8.21638 -3.89162 -5.39246 1.97695 +39 1 7.3932 1.68143 0.910549 14.6159 -16.4356 -32.9418 +40 1 6.52029 2.5195 0.875176 1.21021 -6.27577 -1.18313 +41 1 0.0178952 3.25358 8.17469 3.31384 23.2108 27.1434 +42 1 0.75874 4.10726 8.14569 6.02202 2.9315 8.91628 +43 1 0.895393 3.22207 0.752637 -27.1078 14.1691 0.641871 +44 1 8.18599 4.06691 0.900855 -0.259841 0.495686 -5.35481 +45 1 1.55285 3.22874 8.15747 6.98433 26.3863 8.64396 +46 1 2.49624 4.20319 8.19485 -11.6121 -5.75058 -7.87094 +47 1 2.42547 3.30302 0.888339 10.6882 -12.4594 -2.99107 +48 1 1.6862 4.0108 0.835279 -13.347 15.0654 -7.27246 +49 1 3.22 3.33904 0.0153378 4.70565 -17.4148 -11.2872 +50 1 4.15099 4.01359 0.0472035 -3.25232 -0.128895 -8.82814 +51 1 4.06799 3.24916 0.843927 9.3476 8.05351 2.04714 +52 1 3.19501 4.05 0.736238 12.2088 14.8797 22.981 +53 1 4.93359 3.21205 8.21538 5.02686 8.32666 2.39487 +54 1 5.81852 4.10681 0.0313505 -9.96067 16.6194 -8.35941 +55 1 5.78406 3.36669 0.776887 -2.74739 -9.47942 10.9149 +56 1 4.90983 4.0411 0.864362 0.837356 4.14382 -0.368312 +57 1 6.53897 3.36302 8.19911 9.90234 -20.173 11.5285 +58 1 7.46276 4.04697 0.0534703 -5.76424 1.73449 -3.50806 +59 1 7.34501 3.24442 0.827453 2.34892 5.8087 4.09531 +60 1 6.59021 4.15121 0.905225 -2.44603 -12.1461 -5.89568 +61 1 8.13258 4.93013 0.0905402 6.61239 1.0085 -5.83678 +62 1 0.918786 5.84938 8.18896 -100.34 -125.435 4.75603 +63 1 0.733666 4.90689 0.894865 5.0782 -1.1493 -19.9038 +64 1 8.13743 5.78012 0.885656 21.4143 -27.2006 -30.8387 +65 1 1.67225 4.91657 0.0765019 -6.36422 -5.41993 -9.68754 +66 1 2.43163 5.74665 8.16344 0.0454169 7.36314 0.282499 +67 1 2.52248 4.94902 0.779546 -17.0632 -3.92502 5.40756 +68 1 1.68817 5.73221 0.738326 -10.7061 -22.6586 25.0306 +69 1 3.20519 4.98792 8.20267 13.0471 -20.6699 18.764 +70 1 4.1645 5.8475 0.0144516 -41.0284 -51.2746 -22.2701 +71 1 4.12065 4.85332 0.726813 -6.7392 5.54296 9.04283 +72 1 3.22358 5.72978 0.902951 13.2902 6.38408 -11.6219 +73 1 4.86923 4.9681 8.18768 10.2044 -1.77915 -2.81852 +74 1 5.77301 5.70687 8.13281 -22.5863 16.9623 33.7246 +75 1 5.78731 4.97674 0.770243 -6.25016 -2.29075 -2.78772 +76 1 4.89256 5.78932 0.733037 29.9716 -43.8231 39.093 +77 1 6.61696 5.02048 8.19969 -11.3595 -28.891 -1.36328 +78 1 7.33645 5.74186 0.0277988 27.1444 12.1113 -11.7126 +79 1 7.32557 4.92161 0.798933 6.38759 1.63603 8.88722 +80 1 6.60198 5.76847 0.724174 -12.087 6.06842 22.1567 +81 1 0.0632305 6.4911 0.00261304 -6.53376 9.85675 7.22968 +82 1 0.730752 7.3973 8.19101 19.8665 -4.89129 14.6872 +83 1 0.894205 6.53954 0.906348 -15.672 -5.70878 -18.8817 +84 1 0.0916376 7.35116 0.914882 -39.3163 -12.8553 -54.9509 +85 1 1.54844 6.4779 0.0899714 109.204 121.919 -0.90408 +86 1 2.45374 7.43343 8.1677 17.1682 -16.9212 2.53497 +87 1 2.38485 6.48495 0.871503 16.8711 24.0952 -19.5071 +88 1 1.73482 7.30198 0.918245 -4.50526 25.4363 -21.6583 +89 1 3.35837 6.52948 0.00621289 -17.9347 4.05163 8.57797 +90 1 4.15544 7.30314 8.17418 -3.86421 14.3399 10.028 +91 1 4.18078 6.49797 0.807337 -33.0181 25.5019 29.3461 +92 1 3.28881 7.33369 0.840128 0.0678552 -0.60668 -1.16807 +93 1 4.86711 6.50097 0.0644243 55.2704 56.5162 -42.5456 +94 1 5.6807 7.37537 8.15497 2.37339 1.6253 6.06405 +95 1 5.83906 6.54647 0.813774 -8.31017 -0.439493 -0.862375 +96 1 4.90102 7.33548 0.785855 3.38301 3.17369 4.3776 +97 1 6.62594 6.60016 8.16507 -28.5529 -10.5165 29.461 +98 1 7.41236 7.32596 8.18119 12.8158 16.6867 22.5272 +99 1 7.48788 6.57526 0.906715 -17.6408 15.7915 -12.9219 +100 1 6.60846 7.32088 0.891813 -2.23221 1.45701 -6.99196 +101 1 8.17 8.13088 1.54543 21.7946 28.0076 23.7334 +102 1 0.889634 0.755106 1.5647 -2.22366 9.82139 12.4406 +103 1 0.787312 0.00367743 2.47285 9.7959 7.14049 -7.07183 +104 1 0.0399172 0.910289 2.54829 -10.4426 -54.7685 -48.8923 +105 1 1.70161 0.076186 1.70291 0.655659 -5.9987 -1.53887 +106 1 2.5425 0.840944 1.65312 -5.39214 -2.71573 1.42057 +107 1 2.39333 0.0846015 2.56412 19.1459 -13.6703 -26.8796 +108 1 1.62991 0.895915 2.55976 -9.37186 -8.23605 -42.2796 +109 1 3.3255 0.037006 1.60354 -4.30714 4.73223 -3.06839 +110 1 4.20236 0.841896 1.65063 -10.9567 4.39501 -2.76043 +111 1 4.12511 8.16508 2.38147 6.48597 31.2032 29.2026 +112 1 3.37125 0.822661 2.38548 -3.89508 0.169143 6.57094 +113 1 4.86677 0.028066 1.55007 9.3902 -7.55136 2.71818 +114 1 5.8528 0.805894 1.56988 -29.5994 -6.3857 29.2326 +115 1 5.73944 8.2048 2.38025 -0.334985 15.3443 16.2286 +116 1 4.92058 0.739392 2.48512 1.8123 5.57771 -0.399822 +117 1 6.61747 8.14877 1.63757 -7.92973 14.3058 -0.0863647 +118 1 7.37923 0.805843 1.70616 17.0436 -4.06349 -13.2175 +119 1 7.38533 8.17909 2.55221 2.10247 4.05286 -21.3656 +120 1 6.66981 0.91359 2.42776 -18.0385 -1.7859 9.16667 +121 1 8.21433 1.71804 1.64878 9.58557 -8.70073 -6.06848 +122 1 0.91795 2.50647 1.62107 -49.2165 -42.2319 12.3144 +123 1 0.778719 1.62612 2.3667 15.8366 8.16624 0.723179 +124 1 0.0388825 2.56454 2.43408 -0.65123 -11.9302 4.78295 +125 1 1.70614 1.64161 1.56714 -4.83448 1.54656 8.88708 +126 1 2.55772 2.51525 1.68348 -33.0305 -26.0768 -4.05159 +127 1 2.46774 1.68666 2.4295 -0.728639 -2.90689 1.14987 +128 1 1.58495 2.48207 2.53043 32.1395 -14.2129 -42.8967 +129 1 3.28639 1.69638 1.58862 0.141668 -5.07807 4.69228 +130 1 4.07581 2.46356 1.66204 5.75617 5.24573 6.028 +131 1 4.09064 1.65395 2.45941 5.06207 -1.15698 -3.64398 +132 1 3.2978 2.42597 2.51229 -0.392826 8.06961 -8.70923 +133 1 4.99952 1.60143 1.58928 -25.5713 -7.8385 22.8567 +134 1 5.66634 2.3835 1.71386 21.3679 17.6667 -19.1597 +135 1 5.74656 1.70527 2.50917 3.11288 -14.4009 7.07914 +136 1 4.97163 2.46224 2.45828 -14.3686 2.77193 11.4917 +137 1 6.62989 1.62285 1.56611 -20.0211 14.8617 27.1541 +138 1 7.37036 2.42163 1.58976 1.23932 26.194 15.084 +139 1 7.49234 1.71782 2.38524 -11.5645 -3.14792 16.0927 +140 1 6.57493 2.44646 2.50738 3.76278 -0.484364 -1.65815 +141 1 8.13855 3.28395 1.66364 9.95915 -4.6352 -13.1677 +142 1 0.822632 4.13968 1.61013 -1.66869 -18.1546 6.90643 +143 1 0.836195 3.27368 2.50106 -4.0013 3.27813 -2.23185 +144 1 0.00706469 4.04664 2.42415 6.78153 4.66429 11.0832 +145 1 1.56864 3.19926 1.57501 43.2252 54.2341 22.2486 +146 1 2.37435 4.19613 1.65007 19.5365 -23.6872 -5.11708 +147 1 2.53204 3.33272 2.45976 -10.1616 -1.37273 8.96239 +148 1 1.5958 4.02298 2.45513 4.44558 4.83545 -0.957126 +149 1 3.24862 3.20562 1.71329 33.7169 30.1535 -8.86948 +150 1 4.04966 4.11271 1.69147 14.455 0.133261 -16.0308 +151 1 4.17313 3.29199 2.42566 -5.80506 -5.3643 5.35172 +152 1 3.37886 4.04594 2.4591 -12.864 4.86539 14.8631 +153 1 5.00029 3.3715 1.7428 -16.124 -51.6521 -51.6846 +154 1 5.71525 4.10565 1.71106 18.126 11.5713 -25.6554 +155 1 5.67368 3.37853 2.52254 40.5036 -38.7002 16.4445 +156 1 4.98188 4.047 2.42098 -44.4942 70.6847 47.3189 +157 1 6.52567 3.216 1.71371 -0.385424 4.96723 -0.762826 +158 1 7.40007 4.08176 1.73877 -6.32286 -1.56827 -20.7524 +159 1 7.42837 3.30042 2.4503 -10.1629 -6.83382 9.16894 +160 1 6.52178 4.09551 2.40152 8.21405 -5.0269 3.15343 +161 1 0.00699263 4.85762 1.69229 -17.0824 5.05692 -6.94595 +162 1 0.756152 5.6631 1.60232 14.3979 15.6472 -4.59775 +163 1 0.764682 4.99903 2.39299 18.2885 -21.5851 21.4239 +164 1 0.0800264 5.75765 2.41619 -22.1201 11.2764 3.26076 +165 1 1.60226 4.84293 1.69094 -9.96687 23.2298 -5.36928 +166 1 2.38001 5.77059 1.56073 -4.13582 -26.0328 27.2432 +167 1 2.39304 4.87599 2.45449 3.86796 9.40324 7.0282 +168 1 1.5595 5.8443 2.45554 15.3251 -19.3503 -10.1983 +169 1 3.24805 4.8639 1.55208 5.72697 0.833939 9.91621 +170 1 4.12523 5.83768 1.72183 2.66681 -7.18069 -9.93584 +171 1 4.14719 4.98927 2.48442 -5.36599 -4.29088 6.08995 +172 1 3.29103 5.75037 2.41213 -9.14312 -21.8308 11.1485 +173 1 4.88531 4.96658 1.71552 5.62499 -3.03462 -8.19539 +174 1 5.80164 5.66001 1.66617 -22.0309 23.7646 0.752493 +175 1 5.79599 4.88622 2.4436 -18.3543 9.31939 -6.6266 +176 1 4.94007 5.78406 2.4889 7.47518 -6.1933 -6.95152 +177 1 6.50282 4.96059 1.57437 23.9581 -12.4339 8.07292 +178 1 7.43162 5.77666 1.60532 -16.9632 -9.02864 21.2089 +179 1 7.30902 4.88901 2.38072 1.39073 12.4251 10.603 +180 1 6.52191 5.81931 2.5443 7.19321 -57.902 -45.2674 +181 1 0.0825324 6.49799 1.58172 -0.0568703 17.3702 26.5223 +182 1 0.807327 7.40344 1.54436 38.413 9.53604 44.8678 +183 1 0.85313 6.5885 2.46372 -17.206 13.7674 -10.0743 +184 1 0.0766958 7.42441 2.49843 -14.0409 -5.69227 -10.6889 +185 1 1.56626 6.64679 1.65111 17.2201 -21.881 29.7832 +186 1 2.51758 7.48828 1.7101 -1.12703 -9.37355 7.34939 +187 1 2.48642 6.48139 2.37761 -17.45 9.10758 18.4987 +188 1 1.62607 7.39059 2.4668 5.47881 2.11068 -4.08662 +189 1 3.22096 6.48273 1.68127 15.0894 18.1205 -19.6751 +190 1 4.01435 7.47003 1.70259 9.92584 -36.0532 -31.9009 +191 1 4.01053 6.48307 2.56537 4.58494 43.5966 -38.8488 +192 1 3.31708 7.46346 2.49246 -11.1632 -6.704 4.9273 +193 1 4.97912 6.56412 1.70872 -0.0323444 1.40088 -5.51009 +194 1 5.76314 7.42951 1.73429 -4.71194 -18.4847 -18.3917 +195 1 5.75053 6.57569 2.52583 -15.5416 2.95473 -19.9489 +196 1 4.86788 7.33538 2.51839 21.348 1.25465 -21.9702 +197 1 6.54919 6.48383 1.72129 1.36669 8.74928 -8.3147 +198 1 7.40692 7.48075 1.59274 -4.17636 -24.5364 8.08039 +199 1 7.31105 6.49008 2.55841 18.9084 8.98379 -5.81349 +200 1 6.56124 7.4093 2.46898 3.88266 -3.866 3.64736 +201 1 0.0467578 0.0587236 3.25639 -2.58837 -3.06001 8.14477 +202 1 0.919472 0.840587 3.2901 -13.7955 -3.94396 11.0802 +203 1 0.913851 8.17129 4.10222 -17.0314 2.36091 -15.061 +204 1 8.12452 0.831674 4.11824 2.96137 1.66258 0.705395 +205 1 1.72266 8.12268 3.2983 -16.5809 -0.000561518 15.0322 +206 1 2.36681 0.848699 3.23189 33.3023 -3.20785 26.2082 +207 1 2.52451 0.093755 4.0501 -20.4816 -4.23237 16.7496 +208 1 1.57332 0.89934 4.17862 1.65408 -10.4059 -4.79402 +209 1 3.23411 8.18086 3.33998 20.9401 7.85353 -15.8307 +210 1 4.12777 0.912462 3.28751 -3.54395 -8.15241 -0.704223 +211 1 4.05479 8.16789 4.17086 6.43266 7.42359 -18.6916 +212 1 3.3412 0.763098 4.14988 -8.17365 16.5822 -19.2151 +213 1 4.85923 8.19378 3.30398 3.75427 6.29815 -1.39384 +214 1 5.723 0.836221 3.31262 4.07436 -7.7371 -12.3645 +215 1 5.78765 0.0695661 4.10746 2.41957 -4.40965 -1.14115 +216 1 4.97909 0.892899 4.12401 -13.5931 -16.8127 1.66952 +217 1 6.57108 0.0657357 3.30807 -10.4223 -10.045 -0.47006 +218 1 7.35373 0.738008 3.24493 15.9915 16.7978 9.43624 +219 1 7.34677 0.0332152 4.15763 12.3358 5.5849 -5.20193 +220 1 6.67147 0.918341 4.12524 -9.23951 -11.4667 0.577623 +221 1 0.0788919 1.58016 3.21314 -1.55258 49.5779 50.5391 +222 1 0.904188 2.40885 3.22233 -31.0956 -2.82504 30.7646 +223 1 0.877149 1.74225 4.15165 7.55452 -10.7555 -4.03202 +224 1 0.0936835 2.40444 4.16194 -19.0736 7.56858 -3.47745 +225 1 1.71236 1.61805 3.29179 -19.7602 28.7111 2.45155 +226 1 2.5486 2.41776 3.31547 -43.6679 25.9149 -16.2942 +227 1 2.39734 1.55251 4.06577 15.8032 7.53109 12.4652 +228 1 1.72237 2.5181 4.15876 -10.7679 -10.2774 -3.05137 +229 1 3.23039 1.71099 3.29502 25.8646 -44.0791 -9.55739 +230 1 4.12827 2.45813 3.1934 -6.48806 -10.3202 8.62038 +231 1 4.19407 1.63495 4.09603 -15.4993 6.39445 10.1662 +232 1 3.20761 2.36838 4.07177 19.5744 11.0493 29.9438 +233 1 4.94979 1.63514 3.37535 1.21152 5.67416 -27.5114 +234 1 5.82776 2.47766 3.34313 -3.66364 1.42568 -1.20833 +235 1 5.76542 1.58538 4.03513 14.4098 19.4192 12.2978 +236 1 4.95489 2.43394 4.07273 -1.13246 5.06376 7.36624 +237 1 6.661 1.60077 3.30919 -3.43354 8.94885 -5.94598 +238 1 7.49515 2.56092 3.28033 -10.5336 -12.2625 1.51454 +239 1 7.39275 1.71767 4.16117 3.5537 3.96098 0.811537 +240 1 6.54244 2.56469 4.20941 11.0399 -32.6669 -26.4629 +241 1 8.2116 3.30444 3.37137 5.74747 4.63382 -14.2394 +242 1 0.840624 4.14226 3.27407 -5.48884 -5.61804 0.498093 +243 1 0.734437 3.23139 4.08576 22.8281 5.93798 4.2063 +244 1 0.0471721 4.13123 4.11158 -4.3827 3.27424 0.087671 +245 1 1.70286 3.20807 3.23042 -2.96775 14.0769 10.9943 +246 1 2.38769 4.13105 3.27446 4.88078 -2.82576 -1.60425 +247 1 2.4087 3.28686 4.02353 16.6104 0.201322 7.1777 +248 1 1.69983 4.0678 4.13415 -10.6977 3.91895 2.19645 +249 1 3.34377 3.23634 3.36851 -11.3528 1.51526 -17.2895 +250 1 4.2055 4.03294 3.37597 -23.3492 5.34016 -26.85 +251 1 4.03955 3.26203 4.11941 11.7033 -4.94552 16.1773 +252 1 3.21963 4.01243 4.16102 5.66091 6.82551 -5.40832 +253 1 4.83261 3.19517 3.32313 20.1816 8.52525 -2.26656 +254 1 5.77148 4.16495 3.28824 -31.489 -26.7787 -6.90732 +255 1 5.82425 3.30115 4.19401 -37.1473 -6.40083 -11.3511 +256 1 4.87724 4.09609 4.11549 36.2568 -10.3151 3.06059 +257 1 6.58329 3.33973 3.22197 0.0461967 -7.66729 -2.40242 +258 1 7.43644 4.05966 3.30265 -3.56999 5.92726 -1.37248 +259 1 7.48286 3.29775 4.19646 -3.89008 -9.4431 -11.0777 +260 1 6.47907 4.03353 4.01383 29.8324 22.3851 15.73 +261 1 8.15241 5.02846 3.31122 10.6595 -5.28085 -5.36552 +262 1 0.804631 5.8376 3.20576 13.4276 -32.1322 14.0647 +263 1 0.877129 4.8969 4.13251 -1.47043 5.42126 -0.0257482 +264 1 0.0651636 5.75976 4.1954 -9.31697 -6.72952 -15.907 +265 1 1.57617 4.92532 3.28718 5.51341 5.68743 -3.59864 +266 1 2.42583 5.72219 3.30114 4.35376 1.25963 -4.44713 +267 1 2.4551 4.89394 4.08913 0.180251 2.9051 2.6698 +268 1 1.67099 5.80732 4.08057 -5.18981 -1.73911 5.86888 +269 1 3.33413 4.84944 3.32334 -2.55875 1.02427 -1.99572 +270 1 4.20493 5.83452 3.24979 -21.4386 -63.3893 34.6056 +271 1 4.19181 4.8901 4.01924 -15.0952 14.1984 13.5631 +272 1 3.36551 5.83759 4.08786 -9.40985 -16.2604 3.57159 +273 1 4.9921 4.89151 3.36329 -7.1819 8.21085 -25.7306 +274 1 5.77026 5.74279 3.2372 -19.2661 -13.3988 15.8911 +275 1 5.68576 4.90444 4.10854 12.1482 9.27276 4.35592 +276 1 4.84395 5.80423 4.20869 23.9245 -11.025 -23.296 +277 1 6.4858 4.83859 3.18898 36.5327 24.7135 15.3623 +278 1 7.30315 5.68446 3.36881 -0.385614 18.5722 -20.0571 +279 1 7.37309 4.9455 4.05168 -2.3203 -17.2743 20.9328 +280 1 6.63896 5.83294 4.18727 -7.1922 -10.1498 -0.517575 +281 1 0.0942908 6.52233 3.3159 -35.7657 14.4096 -15.937 +282 1 0.836387 7.40457 3.20726 4.47284 -0.4112 17.4557 +283 1 0.739312 6.64758 4.08638 39.4722 -18.3951 12.5032 +284 1 8.21631 7.30153 4.06221 -15.2581 27.9702 -0.672668 +285 1 1.58758 6.54973 3.25882 10.9016 11.7867 8.01769 +286 1 2.56536 7.3619 3.34369 -76.1678 6.55793 -73.9603 +287 1 2.52556 6.61112 4.10224 -30.5256 -34.6487 7.0656 +288 1 1.62124 7.32393 4.18622 0.536802 -1.56833 -6.92191 +289 1 3.3681 6.64037 3.37818 -8.53205 -51.1792 -62.7851 +290 1 4.15298 7.36163 3.20593 -21.9528 4.612 22.3686 +291 1 4.12464 6.54108 4.035 14.4356 20.1369 22.2034 +292 1 3.19906 7.31073 4.01315 82.3215 73.9575 117.35 +293 1 4.9065 6.52075 3.26638 28.3768 26.425 6.32862 +294 1 5.74138 7.36096 3.25092 -0.970474 8.69807 4.03129 +295 1 5.81652 6.58456 4.03756 -14.737 -0.580193 0.741413 +296 1 4.87586 7.39212 4.03191 6.20313 -4.00572 5.92319 +297 1 6.48611 6.49412 3.21889 20.5434 47.1119 52.8917 +298 1 7.41876 7.4098 3.23912 -0.409624 -8.77258 11.2401 +299 1 7.35972 6.63444 4.07034 1.58562 -5.33459 -2.2315 +300 1 6.64271 7.48657 4.18074 -12.6903 -3.8877 -6.90745 +301 1 8.18545 0.00495327 4.98201 0.835961 10.4978 -8.83054 +302 1 0.830861 0.760813 4.98094 -9.95647 8.66756 -7.1447 +303 1 0.808969 0.00641337 5.74397 -4.48252 1.30502 4.67537 +304 1 0.018812 0.795135 5.84676 0.988121 0.902183 -11.1018 +305 1 1.60862 0.0119183 4.84308 17.0508 -2.91068 17.4808 +306 1 2.50239 0.876955 4.96833 -9.09304 -5.08176 -4.69214 +307 1 2.44832 8.14323 5.81234 6.77585 9.13889 -19.0494 +308 1 1.56911 0.731109 5.75394 17.4698 11.7404 -4.99849 +309 1 3.28793 0.0458368 4.91142 -7.08209 -9.95818 14.0315 +310 1 4.07208 0.823519 4.87126 26.6153 -9.6486 13.2451 +311 1 4.06672 0.0477209 5.80002 10.3282 0.566915 -15.466 +312 1 3.2042 0.88056 5.78404 3.8932 -8.75566 -1.61055 +313 1 5.02696 0.0222739 4.88991 -12.0715 4.27124 3.2294 +314 1 5.73734 0.886325 4.85298 9.71713 -6.59089 13.6933 +315 1 5.79543 0.0389128 5.76135 -3.4407 3.92019 -0.496418 +316 1 4.85161 0.780997 5.82861 2.47749 38.2945 -34.2513 +317 1 6.64858 0.0906911 4.97808 -13.982 -18.784 -13.0607 +318 1 7.30429 0.900733 5.00382 63.7384 -13.5798 -32.445 +319 1 7.4114 8.15633 5.76261 6.64498 1.40027 -2.33346 +320 1 6.66824 0.783026 5.72649 -29.5414 5.85716 47.7215 +321 1 0.0281683 1.66949 4.95949 -0.425666 -3.96058 2.91208 +322 1 0.893447 2.47998 4.9969 -1.93266 1.10148 -5.4469 +323 1 0.843715 1.6221 5.7589 -0.766033 4.56211 -3.21682 +324 1 0.0782454 2.53663 5.73256 -1.35265 -11.3593 -4.90859 +325 1 1.65079 1.66704 4.93767 -0.533365 0.139965 4.11876 +326 1 2.51601 2.38441 4.90805 0.649871 6.98133 -0.140965 +327 1 2.41175 1.72195 5.72474 2.84663 -8.86686 7.73621 +328 1 1.61538 2.54316 5.81674 -0.089029 -19.7728 -12.4678 +329 1 3.35891 1.54703 4.95536 -9.48818 22.4331 -2.56554 +330 1 4.08195 2.54313 5.01426 16.1748 -2.70068 -21.0768 +331 1 4.12034 1.74262 5.81366 10.5637 -13.2904 -3.74489 +332 1 3.37175 2.4672 5.72729 -31.5422 -3.32565 13.6818 +333 1 5.0033 1.68848 4.95948 -13.0392 -13.8401 -3.80319 +334 1 5.66589 2.47997 4.89515 25.4212 2.24436 -8.70857 +335 1 5.79028 1.55903 5.82666 2.05757 18.2253 -24.3713 +336 1 5.0311 2.46113 5.68951 -16.9377 1.04 21.5338 +337 1 6.57827 1.56896 5.01204 -21.5711 32.5342 -4.2816 +338 1 7.31623 2.52382 4.98258 18.6955 -8.52314 -2.25127 +339 1 7.45461 1.64332 5.76278 -16.0261 1.47893 -16.982 +340 1 6.64089 2.42957 5.78128 -11.0128 0.688597 0.00936653 +341 1 0.0932375 3.33117 4.94446 -5.57952 -6.38154 1.87127 +342 1 0.757472 4.19176 4.95128 10.4651 -6.09524 -1.36969 +343 1 0.907905 3.31127 5.7437 -27.4593 -10.6172 -1.55436 +344 1 0.042027 4.05791 5.75958 -12.212 5.31553 -4.25834 +345 1 1.73758 3.25237 5.02547 -7.72352 0.251809 -15.9993 +346 1 2.4871 4.0191 4.9543 -17.108 24.4302 2.09179 +347 1 2.45668 3.23081 5.78465 2.15315 9.79763 4.28788 +348 1 1.58106 4.05092 5.80356 25.1427 18.6418 -4.49313 +349 1 3.19249 3.31456 5.03239 24.0259 -22.2006 -10.8088 +350 1 4.20707 4.15779 4.866 -22.1265 -5.11578 15.6203 +351 1 4.10653 3.22389 5.85277 -11.4198 11.552 -29.8203 +352 1 3.32529 4.01575 5.8236 -9.29377 10.539 -6.33768 +353 1 5.02426 3.35158 5.01899 -31.0395 -2.45923 -24.1365 +354 1 5.68644 4.17189 4.85403 7.36649 -6.63658 10.5871 +355 1 5.74132 3.29275 5.69662 23.2126 4.63385 22.4488 +356 1 4.92531 4.19073 5.71088 -1.56015 -9.54037 12.8094 +357 1 6.54444 3.23385 4.93781 3.72392 28.1796 29.5331 +358 1 7.41233 4.02229 4.92924 -1.20364 12.0626 9.54412 +359 1 7.4663 3.28529 5.82942 -29.7597 -4.87929 -37.7444 +360 1 6.60644 4.05138 5.75927 -5.95188 5.2753 -7.63938 +361 1 8.20344 4.97671 5.0085 -9.77785 -27.0171 -16.098 +362 1 0.764125 5.65629 4.97235 19.2848 26.171 -13.514 +363 1 0.873777 4.9677 5.68286 -0.798932 -14.5746 27.2238 +364 1 8.1297 5.72693 5.67887 36.2224 14.0656 51.1647 +365 1 1.7318 5.02959 5.01529 -5.49043 -14.6131 -16.8314 +366 1 2.44542 5.85219 4.93063 19.3822 -11.3762 -19.1618 +367 1 2.55143 4.96012 5.6972 2.49476 -2.70049 4.14057 +368 1 1.7425 5.82205 5.68004 -17.6493 -28.263 45.9708 +369 1 3.3219 4.92271 4.83646 -0.36054 0.182371 1.57441 +370 1 4.15401 5.67616 4.9285 -21.3575 6.09757 11.4691 +371 1 4.07715 4.94174 5.74451 -0.595544 -7.12056 -1.40506 +372 1 3.31639 5.79418 5.70206 -6.4923 -7.4901 3.07645 +373 1 4.92581 4.94202 4.97984 -0.22012 5.90431 -14.5879 +374 1 5.73821 5.69855 4.88283 0.98112 8.81137 -0.251897 +375 1 5.70683 4.9474 5.70386 9.48927 0.653977 8.8924 +376 1 4.96412 5.79635 5.67508 -8.29845 -17.1654 19.2091 +377 1 6.48765 4.91573 4.91811 9.87445 -1.02048 -0.929801 +378 1 7.42803 5.76565 5.01887 -36.8924 9.29378 -39.8178 +379 1 7.31535 5.01349 5.75729 -2.96639 -15.6116 3.19898 +380 1 6.51112 5.80276 5.76292 -0.511839 0.0343249 -1.86567 +381 1 0.0752499 6.50198 4.93503 -9.95853 14.5519 3.18185 +382 1 0.749032 7.44313 4.93057 9.36322 -4.26106 -6.17112 +383 1 0.799308 6.59761 5.72007 7.23025 -2.947 1.48543 +384 1 0.0646916 7.47006 5.72188 -15.7332 -12.5303 9.25543 +385 1 1.64476 6.54961 5.03014 -20.9538 30.4927 -38.3434 +386 1 2.45435 7.39325 4.88002 3.42796 3.8663 5.03137 +387 1 2.4342 6.59097 5.67369 23.2905 17.249 22.0616 +388 1 1.54778 7.4679 5.8363 19.3115 -12.9738 -21.1698 +389 1 3.32159 6.57391 4.94635 0.920374 5.37222 -4.76541 +390 1 4.12734 7.43087 4.87631 0.0949958 -12.9619 14.1535 +391 1 4.03648 6.57336 5.82487 9.67898 -2.57585 -4.33725 +392 1 3.37401 7.44443 5.83215 -8.90767 -10.0262 -16.7558 +393 1 4.95785 6.5313 4.96795 -5.28369 20.3288 -12.6073 +394 1 5.72446 7.44815 4.95617 -0.295615 -4.81227 -6.28599 +395 1 5.67507 6.56368 5.75557 19.5363 2.36566 3.12879 +396 1 4.99604 7.36578 5.82253 -12.0795 7.56208 -16.0156 +397 1 6.47952 6.65183 4.84549 7.81673 -1.192 17.7565 +398 1 7.49045 7.38842 4.86267 -3.31154 -1.72952 10.3926 +399 1 7.31515 6.64393 5.7627 1.65473 -7.46902 -9.80451 +400 1 6.51213 7.44705 5.67942 6.88055 -5.46286 6.12471 +401 1 0.0806264 0.0886591 6.67061 2.86389 -53.8636 -44.0246 +402 1 0.883633 0.899989 6.55658 -11.6958 -11.9156 5.39561 +403 1 0.88757 0.0447352 7.4623 -6.5852 -8.63148 -1.54458 +404 1 0.00589996 0.782701 7.30583 -3.57511 51.2033 48.3924 +405 1 1.70878 0.0185969 6.53425 -9.91562 -0.171369 19.1044 +406 1 2.47179 0.820184 6.65916 -10.0875 0.778119 -25.3377 +407 1 2.53937 0.0160974 7.34796 -3.95783 -6.52463 5.98309 +408 1 1.62994 0.765044 7.35659 9.0133 10.535 7.11032 +409 1 3.30704 0.041501 6.48376 -12.5346 2.59741 23.4233 +410 1 4.02443 0.849646 6.63591 28.9911 -27.1685 -8.99322 +411 1 4.05271 0.0416361 7.37632 0.533135 -1.75778 -2.17869 +412 1 3.19386 0.898466 7.37702 15.4736 -11.3366 18.5812 +413 1 4.93306 0.0872445 6.49555 4.8751 -33.7979 36.6921 +414 1 5.84884 0.883258 6.55834 -5.60524 -28.829 17.1111 +415 1 5.81564 0.024621 7.40384 -2.36039 -5.56484 -6.47242 +416 1 4.961 0.816895 7.40894 -1.64345 1.03662 -2.05135 +417 1 6.67176 0.000709987 6.50931 -8.49107 -0.789231 11.0199 +418 1 7.42872 0.868407 6.55728 -5.95092 -10.3429 1.39671 +419 1 7.36138 8.18623 7.46478 9.04825 4.48366 -10.7424 +420 1 6.59985 0.825831 7.39669 4.88737 -2.34866 2.27965 +421 1 8.14416 1.67759 6.49013 32.825 -1.32457 17.7447 +422 1 0.9037 2.40379 6.60352 -22.6991 13.3728 -5.6252 +423 1 0.83815 1.6821 7.34463 -6.45777 -9.82884 14.5288 +424 1 8.19206 2.55987 7.48041 1.09967 -24.6646 -31.5822 +425 1 1.61029 1.6565 6.61062 19.3859 -4.50632 -8.40911 +426 1 2.39042 2.47779 6.49991 10.3869 -7.14038 20.8685 +427 1 2.43336 1.66264 7.31159 -0.298923 7.67874 9.60508 +428 1 1.68521 2.53757 7.43341 0.0908995 -20.3899 -19.4953 +429 1 3.34574 1.55658 6.57542 -29.1499 40.141 -5.99747 +430 1 4.09567 2.50385 6.58715 2.92988 -17.1157 8.90269 +431 1 4.06967 1.60141 7.36073 8.28003 9.68724 13.2999 +432 1 3.26291 2.44686 7.41755 -1.72761 -1.27824 0.484775 +433 1 5.02343 1.63061 6.57358 -10.9076 3.24904 2.06921 +434 1 5.8117 2.52535 6.48584 -2.10788 -3.23133 8.48842 +435 1 5.76381 1.64883 7.37339 7.06147 -0.584215 3.21917 +436 1 4.99697 2.44099 7.45915 -1.75923 11.2498 -19.4182 +437 1 6.62044 1.59458 6.63611 -5.65576 11.9066 -13.6974 +438 1 7.40085 2.40641 6.52565 -4.26631 17.0681 5.6259 +439 1 7.4086 1.68173 7.30269 7.67403 -2.22025 20.1658 +440 1 6.56414 2.4958 7.48155 2.02857 -0.65966 -9.40352 +441 1 8.16172 3.22 6.50779 31.0613 6.17733 37.0029 +442 1 0.778923 4.13348 6.47989 7.10682 -1.13444 17.3069 +443 1 0.731543 3.38344 7.32104 8.57141 -10.8353 -0.596329 +444 1 8.20703 4.11651 7.39737 -10.5501 6.3503 -2.89453 +445 1 1.5556 3.22612 6.62242 10.8567 18.3759 1.80723 +446 1 2.43596 4.07218 6.65191 19.5996 1.93234 -23.7547 +447 1 2.42128 3.38357 7.48855 6.46322 -13.7769 -4.42002 +448 1 1.70183 4.1306 7.3251 -28.6202 8.98318 18.3174 +449 1 3.23368 3.21004 6.55845 -1.66335 0.810928 5.98502 +450 1 4.02817 4.01745 6.59179 9.73332 14.3603 -1.234 +451 1 4.04024 3.24371 7.33596 9.19519 -2.61436 13.2612 +452 1 3.33578 4.03204 7.3761 -11.8519 11.1256 7.31388 +453 1 4.84615 3.34919 6.50516 30.474 -3.21025 16.5113 +454 1 5.79338 4.10407 6.63223 -1.4488 4.34379 -6.9657 +455 1 5.71769 3.33306 7.36343 3.56485 -8.31237 5.17357 +456 1 4.89884 4.06687 7.36632 1.94898 -1.38193 2.81677 +457 1 6.61297 3.34048 6.58436 -38.9416 -40.8203 -5.50523 +458 1 7.30794 4.01061 6.56591 40.2005 61.5018 -17.6954 +459 1 7.37741 3.36957 7.31145 38.0889 -52.6112 27.9446 +460 1 6.66665 4.01974 7.42717 -35.3166 42.1921 1.19147 +461 1 0.0452175 4.90338 6.62118 -6.71352 5.92623 -3.01906 +462 1 0.869367 5.66645 6.62279 -29.6122 19.3042 -24.6336 +463 1 0.858776 5.03104 7.45654 -16.814 -24.2615 8.51744 +464 1 8.14658 5.74936 7.4724 2.5583 -5.40279 -7.71149 +465 1 1.59957 4.95319 6.53572 14.873 -15.6204 -6.12191 +466 1 2.54529 5.66468 6.59785 -23.4011 43.3591 -27.461 +467 1 2.4961 5.03005 7.34302 -11.668 -32.1864 28.6337 +468 1 1.60544 5.69113 7.30132 37.8442 13.2739 23.8753 +469 1 3.24356 4.96073 6.59142 26.8133 -25.0989 -5.08933 +470 1 4.09781 5.67439 6.52285 2.63557 7.15813 7.05447 +471 1 4.18105 4.86276 7.35501 -9.07005 4.72655 -1.53462 +472 1 3.36767 5.65499 7.49749 6.09099 26.0319 -27.9028 +473 1 5.01795 4.94278 6.59504 -2.00637 0.995546 -1.6799 +474 1 5.7841 5.85399 6.63871 4.06216 -12.0086 -14.5693 +475 1 5.83404 5.02565 7.38856 -29.8707 -40.8918 -9.03319 +476 1 4.9605 5.83878 7.31445 -12.603 -27.5006 25.6094 +477 1 6.59477 4.88222 6.67554 -4.07568 1.88148 -17.9737 +478 1 7.35313 5.77701 6.52551 0.181186 3.4052 7.13046 +479 1 7.348 4.89641 7.37973 13.5892 1.99375 8.82978 +480 1 6.49663 5.74982 7.4422 46.6685 29.9241 -18.7201 +481 1 0.0491078 6.53098 6.47716 -5.83531 -0.141054 6.60445 +482 1 0.791488 7.40292 6.50563 -8.70546 -0.874788 22.49 +483 1 0.919931 6.51323 7.45776 -11.5314 25.4002 -28.1718 +484 1 0.0481113 7.40468 7.43229 -11.5944 -5.37754 -18.7674 +485 1 1.63473 6.52345 6.62888 -0.301482 5.86022 -13.1885 +486 1 2.54325 7.3746 6.52095 -7.01617 -1.6126 8.94816 +487 1 2.42821 6.65367 7.34715 -0.0947462 -6.49261 12.3075 +488 1 1.66344 7.43005 7.38619 -4.64698 1.83667 -2.7903 +489 1 3.21223 6.51896 6.65614 12.5802 -0.344258 -7.45446 +490 1 4.18524 7.3836 6.50889 -0.948752 5.15796 16.6381 +491 1 4.03479 6.58867 7.43482 10.4531 -7.07785 -21.0648 +492 1 3.31132 7.44815 7.43351 -1.0832 -4.66317 -4.42978 +493 1 5.00814 6.58691 6.66459 -15.2308 20.9466 -24.4589 +494 1 5.70889 7.39626 6.56563 14.4769 6.85637 10.1092 +495 1 5.73775 6.567 7.43094 6.72915 9.63092 8.95959 +496 1 4.91068 7.49261 7.37168 0.330155 -8.28614 -9.94049 +497 1 6.53726 6.65021 6.66417 -1.59265 -6.08794 -3.67401 +498 1 7.37246 7.29875 6.57444 7.56141 13.3939 8.59342 +499 1 7.35261 6.58373 7.49207 23.0737 -16.5957 -35.2353 +500 1 6.60589 7.39349 7.49219 -10.7096 3.92482 -19.5185 diff --git a/examples/mdi/dump.17Jun22.series.driver.tcp.1 b/examples/mdi/dump.17Jun22.series.driver.tcp.1 new file mode 100644 index 0000000000..847432833a --- /dev/null +++ b/examples/mdi/dump.17Jun22.series.driver.tcp.1 @@ -0,0 +1,1527 @@ +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +500 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 8.9390353509656766e+00 +0.0000000000000000e+00 8.9390353509656766e+00 +0.0000000000000000e+00 8.9390353509656766e+00 +ITEM: ATOMS id type x y z f_1[1] f_1[2] f_1[3] +1 1 0.0109462 8.91109 8.87705 -0.258023 0.625273 0.429284 +2 1 0.983178 0.93542 8.91066 -2.88593 0.281032 -1.95154 +3 1 0.886776 0.00353842 0.964105 -0.27179 0.383251 0.443719 +4 1 0.0722273 0.817966 0.815708 -0.663834 1.25489 -0.35451 +5 1 1.82919 8.8603 8.91164 0.346262 0.966337 0.327185 +6 1 2.71374 0.850558 0.0977971 -1.53533 0.952301 -0.539148 +7 1 2.75443 8.9152 0.943835 0.200679 -0.0265554 -0.862232 +8 1 1.72161 0.971413 0.796705 7.79754 -6.0811 1.58835 +9 1 3.47837 0.0294075 0.0515782 2.76325 -2.21894 -0.80311 +10 1 4.43186 0.961325 8.89919 -0.387918 -0.444884 0.950878 +11 1 4.37764 0.00631327 0.801109 0.844344 -0.87322 -0.116598 +12 1 3.59567 0.80748 0.974874 -0.705778 1.85625 -1.80855 +13 1 5.35026 8.89566 0.0208816 -0.442875 -0.272596 -0.473028 +14 1 6.3022 0.978028 0.0782288 -3.05518 -2.94099 -0.889505 +15 1 6.27707 0.0297536 0.962734 -0.0515917 0.772188 -1.05602 +16 1 5.30223 0.918655 0.899444 1.33545 0.759601 -1.29769 +17 1 7.0769 0.0948096 0.0649153 0.098645 -1.06535 0.292165 +18 1 8.09537 0.913626 0.0774105 -0.154847 0.414543 -0.451754 +19 1 8.08165 0.0818588 0.895196 -0.689773 -1.28143 0.929968 +20 1 7.14638 0.885276 0.891299 0.487793 0.733541 0.918445 +21 1 8.89456 1.84483 0.0434425 0.886905 -0.621358 -0.495646 +22 1 0.935681 2.64324 0.0406455 -1.34335 0.213362 -1.25695 +23 1 0.966071 1.69976 0.948945 -7.88058 11.3257 -7.25569 +24 1 0.0121607 2.66637 0.881115 -0.232812 0.533689 1.18415 +25 1 1.85044 1.81859 0.00192994 -1.7495 0.19048 0.1992 +26 1 2.68148 2.7251 0.0685109 -1.25528 -0.916148 -1.01459 +27 1 2.62716 1.70715 0.839166 0.688023 2.33788 1.05919 +28 1 1.6905 2.59418 0.903739 1.58905 0.257971 0.508129 +29 1 3.57454 1.77719 8.88663 0.186742 -0.0628404 0.80372 +30 1 4.38099 2.63699 8.92556 0.253897 0.0578989 -0.178058 +31 1 4.45919 1.78484 0.892793 0.372262 0.580252 -1.28381 +32 1 3.55804 2.657 0.821946 0.208194 0.440929 1.42052 +33 1 5.39579 1.85576 0.0513097 -2.11231 -0.770148 -0.833202 +34 1 6.28486 2.68552 0.0861957 -0.390024 -0.099671 -1.25573 +35 1 6.16167 1.79587 0.852166 3.13123 -0.282736 3.8241 +36 1 5.43841 2.67896 0.926914 -0.906522 -0.132525 -0.585389 +37 1 7.09214 1.72405 8.83985 3.26876 6.20695 4.03515 +38 1 7.96694 2.76043 0.0935037 2.29966 -0.680397 -1.28039 +39 1 8.06525 1.69772 0.940378 0.498274 0.445905 0.0355574 +40 1 7.16698 2.58338 0.88179 -1.8895 -0.0707859 1.12114 +41 1 0.0210451 3.48041 0.0428158 0.862491 -0.329006 -0.681709 +42 1 0.874431 4.40275 0.0131769 0.218928 -0.148848 0.324321 +43 1 0.851364 3.60752 0.914082 0.352487 -0.527665 -0.410754 +44 1 0.0749717 4.51844 0.974577 -0.257295 -0.287753 -0.288054 +45 1 1.76248 3.58626 0.0539576 0.480316 -2.29368 -1.63127 +46 1 2.72367 4.4241 0.0474256 0.0272964 0.241712 -0.452415 +47 1 2.73289 3.61199 0.901343 -0.0645249 -1.94992 -0.502421 +48 1 1.8456 4.38069 0.843492 -0.349918 1.31176 2.27682 +49 1 3.50387 3.55674 0.0315796 1.56114 -0.0224047 0.116984 +50 1 4.49692 4.37908 0.0780585 -4.54206 0.213106 -5.58215 +51 1 4.46671 3.57478 0.880458 -0.334204 -0.938728 0.874478 +52 1 3.58815 4.43 0.950374 0.652985 -1.92511 -1.59862 +53 1 5.3866 3.58372 8.92789 -1.19711 -2.22155 0.617325 +54 1 6.17276 4.37217 8.86047 6.00842 1.34471 4.78274 +55 1 6.27432 3.53871 0.907449 -0.148389 -0.137473 -0.523414 +56 1 5.27909 4.47835 0.809401 8.23917 -3.14067 4.34956 +57 1 7.09737 3.53698 8.87413 0.14026 -0.233191 0.941929 +58 1 7.96586 4.56922 8.84208 6.8748 -6.48505 1.75868 +59 1 8.1189 3.63425 0.96148 -3.00277 -1.46323 -4.15536 +60 1 7.14279 4.43222 0.962078 -0.0459577 0.247999 0.321752 +61 1 8.89637 5.43177 8.92691 0.327116 0.812268 0.0679643 +62 1 0.854018 6.30348 0.0813318 1.06274 -7.24911 -7.87042 +63 1 0.873415 5.41923 0.812761 -0.31071 -0.409433 0.423823 +64 1 8.88236 6.35419 0.863575 -0.753758 -3.06962 -0.690381 +65 1 1.76334 5.40934 8.88249 1.8326 1.29836 1.91996 +66 1 2.68777 6.21767 8.90577 0.0461489 1.51967 -0.262666 +67 1 2.66088 5.41906 0.821357 0.262109 -0.890774 -0.241847 +68 1 1.86017 6.31332 0.804602 -1.38053 -1.13952 0.850174 +69 1 3.64435 5.42051 8.90358 -2.6101 -2.17442 -0.370474 +70 1 4.37466 6.25131 8.85278 3.71832 2.70453 0.946098 +71 1 4.53047 5.2708 0.824393 -3.54051 3.8431 0.931364 +72 1 3.61222 6.27635 0.96909 -4.05414 0.604922 -3.58471 +73 1 5.40042 5.34751 8.8935 -0.719369 -0.36085 0.212296 +74 1 6.18215 6.3156 0.0196993 0.267387 0.110688 0.223648 +75 1 6.27516 5.37868 0.90209 -1.0642 -0.241069 0.481931 +76 1 5.31268 6.25584 0.875522 0.133781 0.115172 0.026661 +77 1 7.20113 5.30633 8.84474 -4.87308 6.78349 0.0391413 +78 1 7.95512 6.30497 0.092705 6.00614 -6.0265 -0.649957 +79 1 8.08767 5.35538 0.811364 -1.15126 0.392579 0.741715 +80 1 7.08607 6.1919 0.926051 0.630581 3.46407 -2.46157 +81 1 8.92405 7.0566 8.88782 -1.53371 0.564813 -0.0213323 +82 1 0.905011 8.13513 0.0600006 -0.504969 -0.194195 -0.00181653 +83 1 0.816253 7.07033 0.801556 1.36958 7.74762 7.34595 +84 1 8.83925 8.07727 0.907684 2.46931 1.67506 1.17354 +85 1 1.86043 7.09328 8.91972 -0.773441 0.857837 1.39948 +86 1 2.76541 7.99166 0.0440794 -0.77809 1.05822 0.425741 +87 1 2.67654 7.18636 0.91183 2.62219 -2.00002 -0.219028 +88 1 1.8788 7.9677 0.915621 -0.894934 2.07357 -1.21117 +89 1 3.59357 7.13026 0.0332195 -0.388167 0.00237965 -0.544686 +90 1 4.38663 8.07233 8.88382 0.174711 -0.440379 0.0897133 +91 1 4.5359 7.22854 0.936578 -2.37627 -1.04519 -2.35662 +92 1 3.63538 7.97981 0.824881 -1.61206 1.29888 2.0997 +93 1 5.3271 7.23059 8.92328 -0.111431 -0.20975 0.289951 +94 1 6.30867 8.05581 8.84577 0.0946421 0.0525728 2.57365 +95 1 6.32003 7.15576 0.891457 -0.2569 -0.483959 0.0547371 +96 1 5.40661 7.9868 0.968462 0.415884 0.0845497 -0.268424 +97 1 7.22798 7.08713 0.0563741 -5.45853 5.72078 -0.51002 +98 1 8.05735 8.06186 0.0753342 -0.611004 1.73052 -2.95918 +99 1 8.10922 7.21906 0.806609 -0.400473 -2.4357 2.42821 +100 1 7.16998 8.08498 0.846622 0.253892 0.388538 0.000271703 +101 1 8.88419 0.00785958 1.88382 0.148531 -0.55276 -3.06718 +102 1 0.806706 0.963107 1.6981 0.146821 -6.1479 7.24676 +103 1 0.81371 8.93107 2.59291 1.58623 0.25767 2.66866 +104 1 0.0914118 0.851308 2.7806 -2.96193 1.34432 -3.85013 +105 1 1.70908 0.055279 1.86232 -0.26684 0.0875329 -0.306957 +106 1 2.72497 0.940903 1.70203 -0.757536 -0.918748 1.71384 +107 1 2.71129 0.0639965 2.67102 -0.311468 0.261861 0.646041 +108 1 1.73889 0.96912 2.64369 0.123913 0.173982 0.666446 +109 1 3.52533 0.0194588 1.83263 1.01391 -0.00454228 -0.284845 +110 1 4.50633 0.992013 1.70842 -3.51938 -2.99082 2.23564 +111 1 4.49463 8.9275 2.60712 -6.23135 -0.421499 6.59704 +112 1 3.51061 0.932206 2.63613 0.265327 0.172351 0.555119 +113 1 5.26459 0.0845656 1.88118 6.41483 1.44516 -5.35427 +114 1 6.26822 0.943133 1.78953 -0.172034 -0.0988047 -0.238973 +115 1 6.20352 0.0931252 2.63772 -0.251863 0.451194 0.97073 +116 1 5.33497 0.961022 2.74861 1.85573 -2.10168 -0.655218 +117 1 7.15143 8.91799 1.69931 0.631991 0.791476 -0.168042 +118 1 8.1075 0.884637 1.85069 -0.145764 0.238097 -0.736312 +119 1 8.10277 0.00424992 2.71008 -1.61591 0.00687295 -1.36275 +120 1 7.06485 0.985537 2.76239 8.19773 -7.92397 -1.18231 +121 1 8.91698 1.83538 1.78872 0.656642 -0.0731624 0.0431027 +122 1 0.901335 2.58954 1.84197 -0.375827 -0.324571 -2.7055 +123 1 0.839546 1.79651 2.68072 1.09251 -0.901613 -0.242728 +124 1 0.0205195 2.75315 2.62687 -0.478759 -0.0106512 -0.67727 +125 1 1.78258 1.70562 1.69835 1.31189 0.545066 2.20675 +126 1 2.77409 2.6552 1.77928 -3.71202 0.456863 -3.25075 +127 1 2.62583 1.79361 2.77487 3.4762 0.328618 -3.48584 +128 1 1.71155 2.69761 2.62919 0.862289 -1.38539 2.38335 +129 1 3.5477 1.79572 1.86096 1.43061 -0.605958 -0.978191 +130 1 4.46749 2.5924 1.76238 -0.0494618 -0.0821277 -0.176353 +131 1 4.52929 1.74324 2.59829 -2.00749 0.662049 0.061349 +132 1 3.48188 2.69682 2.61959 1.88694 -0.141301 3.78311 +133 1 5.34711 1.71486 1.76809 1.96327 2.17405 -0.830705 +134 1 6.24637 2.73306 1.80484 3.10489 -2.12999 -0.788559 +135 1 6.31443 1.71423 2.71392 -8.21546 8.18972 -0.602972 +136 1 5.26572 2.69815 2.75971 0.0267628 0.10355 -0.216257 +137 1 7.18953 1.75159 1.71849 -0.576203 -0.36263 1.38792 +138 1 8.05027 2.77408 1.76451 0.439173 -0.587966 -0.341117 +139 1 8.01591 1.69661 2.74434 0.366947 0.0491547 0.134545 +140 1 7.14772 2.69371 2.58907 0.0738449 -1.92773 2.13155 +141 1 8.86781 3.66165 1.74517 3.90719 -1.47472 3.87657 +142 1 0.936621 4.42773 1.79512 -0.401045 -0.147867 0.321366 +143 1 0.948846 3.59531 2.72105 -0.571635 -0.0105131 -1.06193 +144 1 0.0834486 4.38982 2.63588 -0.524533 1.06652 0.75481 +145 1 1.83432 3.4799 1.75691 0.359017 0.665628 -0.818381 +146 1 2.69175 4.37077 1.75144 0.14004 0.214725 0.925417 +147 1 2.74153 3.6404 2.67912 -0.708299 -3.83642 -3.24565 +148 1 1.87968 4.54846 2.67269 -0.684796 -0.993828 -0.138535 +149 1 3.5441 3.51573 1.77434 0.186245 0.881611 -0.696526 +150 1 4.55171 4.52396 1.79145 -2.75839 -2.91024 -1.57263 +151 1 4.49896 3.65335 2.59498 -1.96388 -1.7196 0.869652 +152 1 3.49741 4.47737 2.77344 8.37692 1.8085 -7.7175 +153 1 5.44145 3.48872 1.74764 -3.05421 3.82286 1.14399 +154 1 6.1743 4.53053 1.74574 0.463366 -1.70291 0.122224 +155 1 6.30198 3.67131 2.70975 -1.07292 -0.185523 -2.51985 +156 1 5.34196 4.38653 2.7007 1.29125 2.52938 -0.102964 +157 1 7.1691 3.54339 1.87445 -0.749456 2.7751 -2.56091 +158 1 7.97266 4.40051 1.79603 0.56071 1.27489 1.72891 +159 1 7.99234 3.49992 2.67525 0.940044 2.40885 0.128516 +160 1 7.18063 4.50303 2.68825 -0.923025 -2.40154 0.0954191 +161 1 8.91159 5.33038 1.82507 -0.0203349 -0.241672 0.333237 +162 1 0.8958 6.32359 1.78851 0.38501 -0.14702 -0.347965 +163 1 0.943571 5.31749 2.71754 -0.318578 -0.34148 0.397124 +164 1 0.0864418 6.28418 2.68726 -1.86154 0.137969 -3.27119 +165 1 1.71465 5.37463 1.6949 -0.232891 -0.268012 0.301526 +166 1 2.72852 6.31988 1.88644 -2.78715 -2.37305 -5.95735 +167 1 2.64735 5.41101 2.73193 1.7471 0.192556 0.973026 +168 1 1.84919 6.27948 2.72157 -0.39498 0.808971 -0.0974847 +169 1 3.48336 5.2657 1.71665 0.625214 2.24561 1.33995 +170 1 4.39296 6.19435 1.72952 3.81534 -0.586193 2.86006 +171 1 4.52517 5.37564 2.62027 -1.99502 -0.45422 2.59567 +172 1 3.56333 6.24537 2.5877 2.83084 0.938216 3.4987 +173 1 5.32581 5.29562 1.86847 5.13697 3.80601 -2.04537 +174 1 6.24758 6.22298 1.79203 0.477004 0.378689 0.56244 +175 1 6.25283 5.44934 2.73731 1.14422 -0.830366 -0.337224 +176 1 5.45416 6.25624 2.6996 -2.42774 -1.74418 -0.22606 +177 1 7.22676 5.41803 1.71412 0.223451 -2.28899 2.0191 +178 1 8.0979 6.3518 1.78861 -0.44204 -0.435572 -0.338725 +179 1 8.01325 5.26918 2.64973 1.18264 0.878361 -0.124926 +180 1 7.11991 6.34415 2.69936 -1.3293 -2.66755 2.78128 +181 1 0.0635545 7.11209 1.72165 -0.371894 2.049 0.790012 +182 1 0.857409 8.07873 1.82753 -0.608672 -0.60495 -0.46291 +183 1 0.930573 7.24697 2.65225 -4.55248 -4.69883 0.513873 +184 1 8.8491 7.95414 2.58819 0.570786 1.09764 -0.00497061 +185 1 1.71811 7.19809 1.77835 0.893245 -0.692356 0.118249 +186 1 2.78024 8.04523 1.70672 -2.88976 2.48107 0.040135 +187 1 2.67012 7.13476 2.61708 -1.16009 2.6938 3.43626 +188 1 1.72659 7.99584 2.64342 2.19305 3.0992 -0.0129086 +189 1 3.48631 7.23394 1.84989 5.35093 -4.92393 -2.00054 +190 1 4.4261 8.04744 1.77118 -0.338387 -0.0128497 0.448007 +191 1 4.41287 7.13619 2.73708 2.81119 1.17101 -3.79683 +192 1 3.52255 7.96143 2.73527 1.04353 0.896155 0.0445218 +193 1 5.31509 7.09458 1.73703 1.75862 -0.357986 2.37379 +194 1 6.31592 8.04277 1.87992 0.07968 -0.344084 0.021952 +195 1 6.19476 7.08883 2.7194 5.13464 2.37882 -2.53303 +196 1 5.31616 7.97076 2.64032 0.139732 0.0575338 -0.0995313 +197 1 7.13779 7.0901 1.87785 -0.856279 1.84142 -1.45962 +198 1 8.00182 8.12007 1.73344 0.812689 0.333431 -0.248462 +199 1 8.01591 7.08327 2.73264 -0.0756439 0.769292 0.331432 +200 1 7.15074 8.00152 2.76416 1.82643 0.942676 -3.56152 +201 1 8.89655 8.9304 3.48678 1.65951 -0.447815 3.8493 +202 1 0.950495 0.819015 3.5162 -1.29532 1.69106 1.16913 +203 1 0.81801 0.0539921 4.51501 3.2278 -0.258036 -5.15445 +204 1 8.85177 0.90744 4.37372 14 -2.90794 10.8129 +205 1 1.78019 0.0426842 3.56938 1.84169 -0.836001 -0.350651 +206 1 2.63146 0.926366 3.57031 0.012479 0.082004 0.331715 +207 1 2.70742 0.0633514 4.41591 -1.37547 -1.33331 0.456319 +208 1 1.7142 0.801654 4.43761 0.662356 1.10176 0.272549 +209 1 3.65397 8.84382 3.54877 -3.56671 5.39916 0.463391 +210 1 4.3911 0.894602 3.52171 0.595814 -0.346452 0.321605 +211 1 4.50401 0.046887 4.49909 -1.14502 -0.949582 -0.274225 +212 1 3.51809 0.843433 4.41351 1.90854 2.37085 -0.229306 +213 1 5.34066 0.0102546 3.52427 -0.108558 0.828678 0.2339 +214 1 6.2908 0.991162 3.59141 -5.23018 -9.53106 -1.9323 +215 1 6.23033 0.0280237 4.46344 1.30838 0.516693 -1.50043 +216 1 5.29132 0.919899 4.38256 0.973507 -2.91573 1.14051 +217 1 7.06389 8.92307 3.63529 1.41369 0.894395 -0.0234904 +218 1 8.13244 0.926287 3.63848 -11.0259 -0.689673 -11.6462 +219 1 8.07431 0.0396355 4.42295 -0.0998371 -0.343464 -0.2111 +220 1 7.15426 0.902415 4.51611 0.37609 -0.87238 -0.174942 +221 1 0.0547819 1.70767 3.52402 -0.0990054 0.634623 1.9504 +222 1 0.990251 2.59589 3.64321 -1.70133 -1.15531 -1.34459 +223 1 0.876254 1.75025 4.46545 0.108846 -0.46015 0.445192 +224 1 8.851 2.6248 4.52232 3.89545 -0.330965 -5.02573 +225 1 1.83233 1.81735 3.53725 -2.40083 -0.602726 2.24699 +226 1 2.73685 2.66072 3.63237 -1.34367 -0.0545412 -0.555358 +227 1 2.76889 1.75912 4.53924 -5.46261 0.887424 -6.31803 +228 1 1.79935 2.60963 4.48075 0.43952 -0.293553 0.768966 +229 1 3.51296 1.81737 3.56522 0.159577 -1.35984 0.863711 +230 1 4.48313 2.73941 3.65804 -0.990489 -8.98093 -5.87222 +231 1 4.37894 1.70897 4.40451 -1.1595 -0.0369555 -0.272198 +232 1 3.5578 2.69572 4.44594 -0.0317478 -0.740538 0.514717 +233 1 5.41644 1.73157 3.63972 -0.214907 2.94643 -2.78853 +234 1 6.22995 2.60145 3.56616 -0.0106554 -0.60109 0.383738 +235 1 6.30303 1.6885 4.42264 -3.32083 3.037 6.44969 +236 1 5.43404 2.73282 4.52181 -0.69148 0.715375 -0.475461 +237 1 7.08666 1.7162 3.65955 7.29974 4.17951 -2.48105 +238 1 8.0318 2.68816 3.49666 -0.181832 0.425298 0.461358 +239 1 8.08432 1.70749 4.5149 -2.31295 1.75558 0.820722 +240 1 7.18431 2.71452 4.51289 0.136997 -0.067144 0.521486 +241 1 8.84691 3.61245 3.64188 4.42683 -0.879675 -3.24184 +242 1 0.916797 4.43325 3.62545 -0.842258 -0.010797 0.0107287 +243 1 0.871748 3.60004 4.51194 -0.301498 0.107107 -0.324598 +244 1 8.92426 4.51452 4.44006 -0.00859866 -1.77564 -0.547037 +245 1 1.68965 3.48331 3.5995 1.50205 1.26015 1.14935 +246 1 2.74619 4.38356 3.49878 -7.16717 1.90489 10.07 +247 1 2.74519 3.65012 4.52097 -2.02388 -3.55766 -1.13857 +248 1 1.75432 4.38414 4.53252 -0.421779 0.409337 0.409015 +249 1 3.58997 3.49254 3.52387 -0.821723 1.10659 0.0739307 +250 1 4.40569 4.52296 3.53187 0.545495 -0.966363 -0.0502063 +251 1 4.38156 3.4874 4.39271 -0.289264 8.2647 7.79533 +252 1 3.54333 4.42257 4.55563 2.80723 11.1106 -9.83606 +253 1 5.27331 3.5295 3.65482 2.61308 2.66186 -0.969787 +254 1 6.16108 4.46828 3.59956 0.599894 -1.41883 -0.240371 +255 1 6.22639 3.63251 4.44985 -0.305031 -0.480252 0.0742084 +256 1 5.31568 4.40222 4.46767 -0.344747 -0.443719 0.00587924 +257 1 7.10015 3.56367 3.49443 2.55034 0.169304 1.35525 +258 1 8.02171 4.37546 3.5697 -1.76106 3.37709 -2.28074 +259 1 8.069 3.64942 4.40708 -2.31714 -3.33053 6.18677 +260 1 7.18438 4.37135 4.52245 -1.79563 0.274401 -0.392524 +261 1 0.0758128 5.3487 3.5652 0.184463 -0.360483 0.192319 +262 1 0.795174 6.30898 3.53894 9.14413 -6.75396 2.48214 +263 1 0.867482 5.30202 4.453 0.791187 0.0370161 0.388706 +264 1 0.00225224 6.31064 4.52093 0.402626 -0.0990512 0.0415993 +265 1 1.75224 5.26394 3.64332 0.696547 0.221295 -0.114908 +266 1 2.74065 6.24856 3.64631 -0.500385 1.40459 -1.64071 +267 1 2.73855 5.4528 4.44688 -5.40773 -5.67129 2.9343 +268 1 1.74472 6.17623 4.53641 0.82995 0.717951 -0.0718944 +269 1 3.48421 5.34442 3.61728 1.66736 -1.06074 -1.09811 +270 1 4.41383 6.35055 3.60638 9.51906 -9.2799 1.43724 +271 1 4.38632 5.26464 4.48258 -0.919101 0.504742 0.900072 +272 1 3.55793 6.1617 4.49469 4.34711 2.82736 -0.340092 +273 1 5.36863 5.28325 3.49178 -0.734818 0.617922 -0.744768 +274 1 6.26503 6.19943 3.66319 0.429882 1.55809 -2.03015 +275 1 6.35487 5.3413 4.44757 0.561767 -0.978785 -0.133344 +276 1 5.27408 6.24166 4.56754 6.98603 1.54355 -5.42942 +277 1 7.19701 5.44828 3.47564 -5.73363 -4.54905 0.0826653 +278 1 7.95668 6.19688 3.55501 6.31824 5.03885 -1.22951 +279 1 8.09251 5.32103 4.3972 -0.525971 0.388914 -0.470954 +280 1 7.21521 6.34275 4.38759 -5.30552 -2.8442 0.851377 +281 1 0.0775826 7.08234 3.53581 -5.46769 7.72822 0.0708503 +282 1 0.933572 7.95134 3.59844 -0.0755868 -0.81045 -0.0294233 +283 1 0.967321 7.07254 4.42487 -1.68738 -0.0136546 1.81969 +284 1 8.87247 7.95576 4.3937 0.743652 0.272325 -0.92866 +285 1 1.76917 7.11669 3.64005 0.930468 -0.723585 -1.50003 +286 1 2.76456 8.10499 3.62233 -0.317456 0.121935 0.766743 +287 1 2.61456 7.10311 4.56718 0.759736 -0.536182 -1.28605 +288 1 1.85332 7.96709 4.49102 -0.903085 0.0612931 0.171005 +289 1 3.6668 7.06536 3.52857 -12.7314 9.15268 1.72289 +290 1 4.37522 8.04334 3.61636 3.8155 -4.43194 -0.0509001 +291 1 4.53661 7.19684 4.42303 -0.089737 0.0836956 0.326132 +292 1 3.62847 8.06443 4.56174 -6.53673 1.14979 -7.53287 +293 1 5.44626 7.09379 3.53396 -2.70855 0.0837127 2.61511 +294 1 6.30058 8.08668 3.48692 -3.50797 -0.210369 1.40313 +295 1 6.24642 7.05504 4.56658 1.23504 0.486666 -1.51311 +296 1 5.40389 8.14153 4.41484 -1.1149 -1.90428 -2.07503 +297 1 7.0793 7.23572 3.56625 0.390898 -5.13728 0.366365 +298 1 8.02564 8.11993 3.55841 -0.989908 -0.0289504 0.0817166 +299 1 7.96341 7.11444 4.5691 3.18586 3.20848 -0.902141 +300 1 7.14662 7.9965 4.39373 -0.0363915 0.663241 1.28885 +301 1 0.0665117 0.0620058 5.29566 -4.76408 0.0634028 3.8487 +302 1 0.920378 0.847838 5.33345 0.704711 1.73157 1.07432 +303 1 0.90733 0.0507073 6.29492 -0.256865 0.383558 -0.568888 +304 1 0.0695806 0.935871 6.21245 0.520609 -0.18085 0.460935 +305 1 1.7158 8.90069 5.2688 0.480844 0.845699 -0.0820744 +306 1 2.72956 0.862321 5.35582 -0.666933 0.680843 -0.243728 +307 1 2.75788 8.89573 6.26927 0.729554 0.867268 -0.717865 +308 1 1.87787 0.918127 6.17945 -0.463015 -0.230718 0.375845 +309 1 3.57292 0.0827463 5.28099 -0.282881 -3.17985 0.660183 +310 1 4.39889 0.831174 5.46088 -0.653335 9.17872 -7.1909 +311 1 4.53367 0.077487 6.1821 0.157227 -8.03625 7.38236 +312 1 3.56635 0.935389 6.31146 0.221361 0.0036999 -1.2625 +313 1 5.44773 8.84526 5.27719 -1.51548 1.46139 3.00719 +314 1 6.272 0.802404 5.33609 -0.667532 1.91594 -0.251293 +315 1 6.22537 8.89219 6.16591 -0.245349 -0.895062 1.43446 +316 1 5.33827 0.94153 6.32303 -1.13614 0.583964 -0.338203 +317 1 7.11863 0.0577427 5.44516 0.0248025 -1.55594 -0.512164 +318 1 7.97781 0.796351 5.39903 0.844611 2.54625 -2.84321 +319 1 8.06017 8.92765 6.18069 -0.104306 -2.31947 1.77241 +320 1 7.18164 0.989783 6.31023 -0.163547 -0.192109 -0.79717 +321 1 0.0916103 1.88258 5.39516 -1.00186 -1.43206 -0.661702 +322 1 0.982314 2.60245 5.42151 0.964023 2.57135 -1.73713 +323 1 0.897632 1.84422 6.25233 0.598171 -0.657266 0.69786 +324 1 0.0925235 2.7239 6.16577 -1.60764 0.211114 1.61705 +325 1 1.82959 1.77578 5.39133 -0.293694 0.755656 -0.589776 +326 1 2.69272 2.74727 5.44011 1.7292 -2.84836 -1.30998 +327 1 2.6889 1.83234 6.17525 0.647659 -0.90616 0.231454 +328 1 1.77521 2.70825 6.28078 0.536701 -0.406727 0.0293567 +329 1 3.51954 1.69427 5.29216 6.69261 0.0739574 6.33581 +330 1 4.4097 2.73314 5.34432 0.344675 0.135757 -0.187596 +331 1 4.40444 1.82369 6.16689 4.836 -4.97823 0.364517 +332 1 3.67178 2.60038 6.25743 -5.49724 5.54416 -0.00203516 +333 1 5.35146 1.77827 5.39473 -0.235283 0.213892 0.835574 +334 1 6.28399 2.77802 5.42862 -0.340126 -0.250486 -0.411738 +335 1 6.23134 1.81375 6.22687 0.0223138 0.244736 0.523936 +336 1 5.32351 2.70513 6.28288 3.08354 -1.69468 -3.77436 +337 1 7.14617 1.80036 5.35567 0.0919136 -0.311209 -0.475968 +338 1 8.0974 2.70612 5.29285 -7.26474 -2.41437 5.10983 +339 1 8.1011 1.88391 6.31294 0.0553936 -2.83177 -2.84321 +340 1 7.18351 2.67214 6.17899 0.615225 -0.197791 1.28477 +341 1 8.87232 3.47935 5.28683 2.9021 4.26792 0.541835 +342 1 0.935261 4.37233 5.44726 0.629241 0.918492 -0.917538 +343 1 0.919878 3.52494 6.23281 0.869805 0.127506 1.01894 +344 1 0.00431382 4.37186 6.33532 0.0302966 1.00444 -0.578346 +345 1 1.87251 3.50381 5.42034 -2.4415 2.77086 0.0779929 +346 1 2.70362 4.48406 5.3041 -1.90814 0.882252 2.42793 +347 1 2.75055 3.50273 6.30756 -1.47013 1.25632 -0.795276 +348 1 1.84448 4.4497 6.22456 -0.665656 -0.501499 -0.145372 +349 1 3.61741 3.6732 5.27884 1.4909 -8.59965 8.97662 +350 1 4.55362 4.53069 5.43699 -1.55164 -1.28771 -1.47171 +351 1 4.52256 3.52483 6.1944 -1.86903 1.10409 1.578 +352 1 3.65361 4.51782 6.21866 -3.39722 -3.70857 0.481797 +353 1 5.32088 3.65892 5.41856 2.55855 -1.45769 -1.45685 +354 1 6.25422 4.4123 5.33119 0.406295 0.346858 0.292537 +355 1 6.15978 3.47786 6.34128 0.227911 3.77427 -2.75081 +356 1 5.33342 4.43001 6.30433 -0.582231 -0.0994195 -0.382533 +357 1 7.19473 3.56016 5.44441 -0.898652 0.294925 -2.64663 +358 1 7.98682 4.41046 5.33513 1.4916 0.0945815 1.20731 +359 1 7.97947 3.58929 6.2697 1.92008 -1.0462 0.640867 +360 1 7.19164 4.45465 6.22659 0.298273 0.832684 -0.26134 +361 1 8.91866 5.33922 5.43231 0.972904 -0.678404 -1.89043 +362 1 0.863832 6.24178 5.44793 2.40494 -1.34388 -3.01765 +363 1 0.840212 5.37684 6.26703 1.52144 -3.32025 -2.26664 +364 1 0.0375152 6.17563 6.19921 -3.52547 2.50803 1.96141 +365 1 1.71406 5.31325 5.33193 0.359992 -0.20317 1.05182 +366 1 2.70446 6.22369 5.28953 -1.67496 -0.128385 2.17513 +367 1 2.62094 5.31478 6.20919 0.620292 0.0770975 0.0647467 +368 1 1.78318 6.16446 6.20286 -0.707464 0.30734 -0.850222 +369 1 3.5001 5.34304 5.42111 1.18155 0.33408 -1.88423 +370 1 4.48409 6.21311 5.27474 -6.47906 -0.498054 6.10955 +371 1 4.40434 5.30746 6.24861 3.30032 4.47126 1.95885 +372 1 3.65651 6.23636 6.35732 0.258101 -0.821502 -0.539452 +373 1 5.37686 5.39062 5.45706 -0.495794 0.303868 0.87367 +374 1 6.27665 6.3275 5.44876 0.578726 -4.19567 -0.915026 +375 1 6.28987 5.34918 6.28481 -0.689441 0.646514 -0.025026 +376 1 5.38856 6.30438 6.29204 -0.62461 -0.174266 -0.144794 +377 1 7.10303 5.36134 5.39788 0.303084 -0.453051 0.575398 +378 1 7.97278 6.2689 5.34555 1.29349 -0.0892034 0.239307 +379 1 8.1123 5.2681 6.25774 -0.648694 -0.661016 0.761589 +380 1 7.23419 6.34793 6.22344 -1.98134 -0.75315 1.10815 +381 1 0.0530217 7.08624 5.43675 -2.76329 0.356415 -1.34254 +382 1 0.891502 8.07734 5.33574 -0.449954 -0.433341 -0.0145848 +383 1 0.859902 7.08778 6.21702 1.22817 0.316603 2.39974 +384 1 8.86723 7.96664 6.28254 0.557062 3.16551 -3.15026 +385 1 1.77928 7.05564 5.34292 -1.2854 -0.797113 0.726349 +386 1 2.74792 8.05162 5.34603 0.580474 -0.247926 -0.00393627 +387 1 2.61984 7.13654 6.2076 0.1179 0.00397349 -0.327299 +388 1 1.73531 7.99204 6.32624 -0.619957 1.84241 -1.57732 +389 1 3.59984 7.17613 5.43634 -0.452415 0.706682 -0.14784 +390 1 4.39821 8.05962 5.28157 7.32724 0.749963 7.12774 +391 1 4.53389 7.20586 6.21186 -1.71384 -1.49003 0.809357 +392 1 3.66572 8.09269 6.23368 0.381787 -1.59697 -1.53597 +393 1 5.43811 7.11751 5.40192 -5.5589 -0.00418968 -4.06356 +394 1 6.35445 7.96959 5.31467 -2.59984 2.44569 0.360222 +395 1 6.17375 7.13942 6.18142 5.31103 3.8936 7.8957 +396 1 5.29125 8.02549 6.29493 1.99742 1.43167 0.441829 +397 1 7.11664 7.15874 5.38774 1.63444 -2.12611 -0.430051 +398 1 8.12983 8.0005 5.26693 -0.350623 0.791023 2.07438 +399 1 8.11089 7.10521 6.29529 -1.02761 -0.414645 -0.639575 +400 1 7.1542 8.04467 6.33119 -0.716395 -2.97685 -2.97233 +401 1 0.0455321 0.0581059 7.13785 -2.59331 -3.08955 0.589456 +402 1 0.853998 0.797568 7.23372 2.25232 12.9399 -9.25923 +403 1 0.893883 0.0531987 7.95582 -0.265032 -9.78891 10.4341 +404 1 0.0979374 0.927475 8.08374 -1.27945 -0.625441 0.909779 +405 1 1.70883 0.0184568 7.15475 0.947479 -0.211015 -0.0644084 +406 1 2.65212 0.910749 7.07723 -0.301347 -0.213339 -0.337826 +407 1 2.6305 8.90469 8.0727 2.55272 1.71066 0.384582 +408 1 1.75018 0.91387 8.02574 -0.526684 -0.686186 -0.483147 +409 1 3.61403 8.84934 7.06612 1.02988 1.44024 1.76178 +410 1 4.42034 0.91943 7.17223 0.522178 -1.61468 -2.10925 +411 1 4.37056 0.0516865 8.14003 0.0263315 0.189467 -0.466418 +412 1 3.59 0.934896 8.00045 0.0371044 1.00787 1.05016 +413 1 5.2816 0.0108877 7.14004 0.0410715 -0.366939 -0.311788 +414 1 6.23624 0.898837 7.05965 1.021 0.941131 0.654753 +415 1 6.246 8.87468 8.06175 -0.280098 0.535663 -1.1759 +416 1 5.31648 0.815501 8.12607 -0.78801 0.243527 -0.599256 +417 1 7.10707 8.84874 7.08197 -0.468775 2.08644 1.86713 +418 1 8.05013 0.946529 7.22788 -1.5208 -0.582053 0.186559 +419 1 8.1301 8.84043 8.01457 0.052244 0.715074 -0.282442 +420 1 7.06838 0.987221 8.03414 10.0415 -13.6791 -1.19755 +421 1 8.86835 1.70934 7.22731 2.54892 2.22649 -0.22541 +422 1 0.866325 2.76414 7.15029 -0.0137847 -2.49225 -3.8584 +423 1 0.826708 1.83336 8.03111 1.70357 -1.53255 0.309164 +424 1 0.0511912 2.65175 8.02861 -1.53037 1.53618 -0.152554 +425 1 1.7237 1.71044 7.1133 -0.3904 -0.435435 -0.731182 +426 1 2.66636 2.72018 7.14295 0.547793 -0.274295 0.648117 +427 1 2.70105 1.80209 8.13576 -0.0852062 -0.133841 -0.000493208 +428 1 1.77492 2.76081 8.10399 0.564357 -0.308093 0.985398 +429 1 3.66205 1.87543 7.16799 0.15905 -2.5091 -2.55207 +430 1 4.55348 2.70177 7.05301 -5.50098 -2.53366 3.01389 +431 1 4.46818 1.71608 7.96441 0.32513 1.80226 3.00161 +432 1 3.56091 2.58808 8.02945 0.396266 1.95642 2.12785 +433 1 5.36149 1.84637 7.16969 0.516803 -0.0610583 -0.802699 +434 1 6.28291 2.77184 7.1854 -0.512674 -3.17359 2.22694 +435 1 6.3427 1.71551 7.9726 -15.2061 11.4078 1.6664 +436 1 5.45463 2.61593 8.09933 0.73198 1.12429 -0.810915 +437 1 7.14617 1.80598 7.24022 4.03182 0.503759 -4.81039 +438 1 8.07521 2.6756 7.07092 -0.336894 3.22322 3.478 +439 1 8.11875 1.8373 8.10797 -1.57974 -0.493075 -0.537868 +440 1 7.09714 2.63714 8.02739 -0.0173147 0.820696 1.90431 +441 1 8.85027 3.56499 7.15253 3.00565 -1.27064 -0.682205 +442 1 0.885235 4.38222 7.18774 -1.842 1.22146 -0.226395 +443 1 0.884771 3.48141 7.97536 -0.530218 4.3971 3.23625 +444 1 0.0419078 4.41462 8.04436 -0.806344 -0.262731 -0.956831 +445 1 1.73746 3.66699 7.09267 1.85773 -3.96877 -1.41987 +446 1 2.66489 4.55163 7.19564 0.399017 -1.47837 -0.325749 +447 1 2.68401 3.61278 8.06372 0.262338 -0.0680464 0.329915 +448 1 1.80878 4.38262 7.9551 -1.46544 1.49945 2.09645 +449 1 3.55441 3.63471 7.17184 -0.0924634 0.45212 0.606799 +450 1 4.40759 4.53436 7.23701 0.160045 0.252781 -1.03281 +451 1 4.47938 3.49218 8.04219 0.177099 0.0940276 0.00712601 +452 1 3.55379 4.48752 8.06012 -0.927856 0.341505 -0.0833457 +453 1 5.30335 3.52949 7.1279 2.00125 1.71282 0.0663191 +454 1 6.19233 4.44015 7.09395 -0.123778 -0.82645 0.684973 +455 1 6.31698 3.55227 8.05766 -1.80584 -0.932697 -1.1518 +456 1 5.41804 4.43351 8.09204 -4.30063 -0.218755 -3.96516 +457 1 7.232 3.50321 7.24512 -0.569054 0.129485 -1.05452 +458 1 8.04777 4.39134 7.10023 -0.415559 1.27013 1.1937 +459 1 8.09921 3.54644 7.99275 -0.904288 0.185761 1.62031 +460 1 7.15284 4.38151 8.0646 -0.281528 0.0795406 -1.17401 +461 1 8.85944 5.36104 7.19522 1.71386 -0.372777 -2.67299 +462 1 0.808445 6.15874 7.05432 0.343929 1.70028 2.25424 +463 1 0.99266 5.36055 8.05319 -1.96195 -0.361049 -1.35199 +464 1 8.9228 6.22111 8.03716 -0.328906 0.253391 -0.16959 +465 1 1.7511 5.27554 7.16317 -0.501838 -0.493478 -1.59379 +466 1 2.7323 6.31099 7.08452 0.463177 0.0720173 0.389338 +467 1 2.75106 5.38162 8.09911 0.530948 -0.923774 -0.761524 +468 1 1.80446 6.33727 8.00982 0.567564 -0.353842 0.999402 +469 1 3.53218 5.32026 7.15711 1.3552 1.44822 0.141569 +470 1 4.49512 6.19462 7.20137 -2.95094 2.57244 -4.09211 +471 1 4.4829 5.43783 8.04952 -1.75843 -3.70774 -0.194014 +472 1 3.65767 6.24252 7.97233 -2.18137 -0.334806 -0.189717 +473 1 5.35752 5.46295 7.14871 1.05371 -2.23541 -1.50951 +474 1 6.22804 6.29485 7.12141 -0.370188 0.264704 -0.149428 +475 1 6.34127 5.4593 8.01496 -0.759119 0.239406 -0.0100712 +476 1 5.27101 6.21963 7.98358 4.21356 3.70888 3.53999 +477 1 7.2413 5.39744 7.15422 0.63332 0.408861 0.0765336 +478 1 8.01209 6.33115 7.20214 1.04149 -1.50251 -0.643312 +479 1 8.11155 5.33363 8.02803 -2.08279 1.51127 0.153008 +480 1 7.20203 6.31049 8.06426 -0.105023 -0.935886 0.140492 +481 1 8.92362 7.24394 7.10015 0.0792153 -3.18157 4.09933 +482 1 0.865164 8.02092 7.22606 2.85769 1.65383 -2.61434 +483 1 0.86745 7.15339 8.01815 -0.578541 -0.380635 0.364655 +484 1 0.0284189 8.08161 7.95725 -0.890268 -0.349283 1.10066 +485 1 1.85656 7.22057 7.11535 0.397315 -1.70504 3.16253 +486 1 2.77375 7.96501 7.15423 0.0953595 0.0574297 -0.272157 +487 1 2.64437 7.22314 8.11966 1.48696 -0.179689 -2.12782 +488 1 1.85941 8.11413 7.96635 -2.35368 -2.50728 -0.754549 +489 1 3.67468 7.10829 7.12824 0.65987 0.70298 0.656082 +490 1 4.46621 7.99739 7.2078 2.25404 -0.456947 -2.59682 +491 1 4.48001 7.09955 8.01357 0.0334801 0.324585 -0.290932 +492 1 3.6378 8.02597 7.95299 -1.96867 -0.619231 2.20677 +493 1 5.31589 7.17259 7.15585 0.23145 -0.930936 -0.437425 +494 1 6.20936 8.03122 7.09513 -0.13604 -0.296447 0.152582 +495 1 6.17543 7.22187 8.09898 5.44884 -7.61495 -1.62058 +496 1 5.43883 7.98222 8.0181 -6.37262 6.00913 -1.00537 +497 1 7.14576 7.09705 7.14015 0.407174 1.49093 0.0363952 +498 1 8.02588 8.07609 7.1284 1.43118 -1.40285 -0.689018 +499 1 7.99317 7.15919 8.00286 1.19218 0.601266 0.682892 +500 1 7.2435 8.04597 7.97482 -1.89044 -0.246287 0.1524 +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +500 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 8.5498797333834844e+00 +0.0000000000000000e+00 8.5498797333834844e+00 +0.0000000000000000e+00 8.5498797333834844e+00 +ITEM: ATOMS id type x y z f_1[1] f_1[2] f_1[3] +1 1 0.0109462 8.52194 8.48789 1.60777 3.16074 4.93288 +2 1 0.770239 0.886587 0.0775241 5.1148 0.619933 -4.35337 +3 1 0.914855 8.54009 0.795212 -2.54709 2.40671 3.27622 +4 1 8.53949 0.79582 0.824294 -1.87361 -0.316163 2.22706 +5 1 1.68126 8.45058 8.49491 -0.796772 17.9401 13.8601 +6 1 2.49257 0.906431 0.000759221 8.8197 -0.476032 2.96817 +7 1 2.62932 0.0354753 0.888378 -4.43263 -0.45206 -5.76212 +8 1 1.71329 0.913566 0.778252 -3.74188 -4.37189 3.26227 +9 1 3.42175 0.0965993 8.49503 -4.75784 -8.08943 10.1901 +10 1 4.21271 0.889278 8.46971 8.07159 3.26979 7.09905 +11 1 4.30903 0.0721078 0.771319 -2.20196 2.16322 3.01896 +12 1 3.42332 0.912751 0.876126 -1.2014 -0.27869 -2.68959 +13 1 5.04057 8.48132 8.46735 12.114 4.06773 4.60111 +14 1 5.95626 0.830289 0.0884189 2.64036 5.56585 -7.9642 +15 1 5.95178 0.0392781 0.802073 0.496214 -5.11156 5.55524 +16 1 5.1151 0.919125 0.80056 -4.53937 -3.75487 2.57161 +17 1 6.8031 8.46299 8.54479 -1.12262 1.88258 -1.67969 +18 1 7.77702 0.837169 8.46101 -2.81144 0.601723 4.97774 +19 1 7.61766 0.0190488 0.807902 2.02145 -3.01975 -0.996798 +20 1 6.83813 0.841817 0.893784 2.20091 1.15146 -3.46095 +21 1 0.00483518 1.7748 8.45086 3.14001 0.0124508 7.14446 +22 1 0.925315 2.54775 8.47859 -2.14676 3.17757 1.68537 +23 1 0.946475 1.73152 0.932031 -7.90083 -3.0997 -5.49951 +24 1 0.0820864 2.59152 0.95052 -16.5003 -1.1863 -19.4267 +25 1 1.62363 1.68342 8.4651 1.8496 1.86303 2.33818 +26 1 2.56251 2.66233 0.0202936 -6.7309 -4.60627 -0.0436147 +27 1 2.47347 1.71611 0.900003 2.27232 1.93928 0.205074 +28 1 1.66562 2.5538 0.89239 8.29789 -0.0162708 -2.14995 +29 1 3.47808 1.70927 8.49067 -6.21947 -0.00998514 1.91211 +30 1 4.19294 2.51037 0.0787296 16.1199 8.28753 -17.6776 +31 1 4.29711 1.73051 0.787489 0.142042 -5.75402 7.11231 +32 1 3.43681 2.6439 0.75999 -11.309 -9.11906 21.9869 +33 1 5.20599 1.76704 0.0398807 -10.2389 -11.7619 -5.76949 +34 1 5.91436 2.52733 8.51501 10.4145 9.83206 -1.49498 +35 1 5.9033 1.67223 0.919622 10.1161 4.25667 -5.1777 +36 1 5.15205 2.55373 0.788133 -1.76953 2.31199 6.90362 +37 1 6.92232 1.70971 0.0701593 -2.50899 -1.62202 -0.822044 +38 1 7.5955 2.61765 0.0592135 2.55821 0.640647 0.0382532 +39 1 7.74881 1.7729 0.896218 -1.59166 -5.96851 -6.46077 +40 1 6.80231 2.56106 0.910949 5.84287 -4.44794 -4.99646 +41 1 0.028349 3.48236 8.49963 2.5025 -5.04288 3.39467 +42 1 0.836484 4.27887 0.0816773 0.760548 2.93196 -2.43461 +43 1 0.942186 3.3633 0.783926 -3.69777 5.09684 -0.0674025 +44 1 8.51583 4.33027 0.838505 2.60137 -0.826864 1.21094 +45 1 1.65067 3.4812 8.47243 0.730068 -2.57113 1.91442 +46 1 2.5668 4.2649 8.54781 -0.773361 3.29166 6.51609 +47 1 2.51515 3.35935 0.92744 0.397687 12.5391 -13.0985 +48 1 1.73465 4.30243 0.83421 -1.47193 -2.67124 0.923933 +49 1 3.37869 3.37397 0.0291446 3.12688 15.3224 -6.53558 +50 1 4.34738 4.34434 0.00829503 -5.52046 -6.93359 -2.07611 +51 1 4.32411 3.36572 0.836745 -2.16657 1.87946 3.00206 +52 1 3.33524 4.20214 0.9322 3.17725 3.34929 -6.83564 +53 1 5.08499 3.41929 0.036632 4.03928 -2.58738 -4.81317 +54 1 6.04127 4.33974 8.49644 -0.624803 -0.102814 0.982479 +55 1 6.01611 3.33685 0.909561 -5.08671 5.06768 -6.62403 +56 1 5.207 4.2377 0.760733 -1.32975 0.891019 3.81461 +57 1 6.81304 3.47817 0.0178755 -0.843928 -8.06693 -2.50137 +58 1 7.73203 4.2048 0.00740382 -1.99245 1.66716 -1.57857 +59 1 7.78831 3.44874 0.953497 -3.78613 -1.03229 -4.77194 +60 1 6.90781 4.17709 0.825008 -1.46363 4.64194 5.22986 +61 1 8.46845 5.09622 8.47404 12.6898 1.90364 12.9104 +62 1 0.797366 5.93181 8.52222 2.38416 2.33873 2.4531 +63 1 0.806155 5.19524 0.885366 4.86564 -4.44474 -2.27198 +64 1 0.0123025 5.95271 0.830227 -4.90982 1.72838 0.59014 +65 1 1.70825 5.09756 8.50872 2.27411 3.17124 11.7261 +66 1 2.57892 5.99612 8.47434 -1.64581 0.780097 1.78814 +67 1 2.53606 5.08073 0.912891 1.82428 2.12405 0.338003 +68 1 1.76245 6.06361 0.855052 -0.817516 -1.26047 -0.587481 +69 1 3.36815 5.1611 0.0892763 -1.75416 -1.94918 -4.15038 +70 1 4.34388 5.99478 8.53994 -9.12199 -5.82315 -0.643131 +71 1 4.22842 5.14974 0.779802 4.93843 -0.926739 3.98855 +72 1 3.45177 5.94376 0.905424 -5.40353 3.18508 -3.48186 +73 1 5.06545 5.13306 8.4631 8.02458 6.68819 3.23791 +74 1 5.91929 6.01015 8.53548 3.77131 -1.20656 -2.03594 +75 1 5.88805 5.11842 0.816496 5.73582 1.96394 -4.01157 +76 1 5.18785 6.02276 0.820364 -9.36617 -3.77225 -2.84856 +77 1 6.8933 5.1517 8.49766 -1.10898 -0.445881 0.788116 +78 1 7.73242 5.99103 8.48869 1.48322 -7.68495 9.10162 +79 1 7.66553 5.0457 0.7869 0.413505 3.32493 1.60624 +80 1 6.9298 5.9353 0.896867 -3.44217 0.759559 -1.89572 +81 1 0.0757853 6.76414 0.08264 -2.09776 5.63137 -2.35842 +82 1 0.929754 7.68563 0.0937614 -14.24 2.10473 -10.1605 +83 1 0.947372 6.93568 0.898093 -37.7638 -41.2899 -5.14895 +84 1 0.0463649 7.75037 0.902481 -0.259219 -2.38896 -3.08434 +85 1 1.64115 6.89463 8.52754 6.28385 -7.53573 1.49633 +86 1 2.53763 7.75472 8.45351 15.1175 -6.89071 16.4408 +87 1 2.60347 6.88355 0.853331 -4.53589 -3.86491 -4.69681 +88 1 1.61173 7.63221 0.905993 43.7793 33.7511 -1.13346 +89 1 3.3813 6.82692 8.54355 -0.238432 1.95456 2.34043 +90 1 4.24371 7.77989 0.043504 -5.67067 -7.72392 -1.84442 +91 1 4.1828 6.86814 0.818276 1.21815 -0.827933 0.630987 +92 1 3.3368 7.7382 0.923275 7.52639 -2.01137 -4.72269 +93 1 5.071 6.7563 0.010658 5.49209 11.6713 -3.15323 +94 1 5.90188 7.6356 0.0424163 1.86621 0.862931 -1.97936 +95 1 6.03172 6.8673 0.938495 -1.34369 1.09475 -9.39496 +96 1 5.15248 7.77523 0.857214 -2.90101 -1.73408 2.05686 +97 1 6.89959 6.76423 0.01648 -11.1028 0.34724 0.750719 +98 1 7.65506 7.70409 0.0429309 2.74021 -1.34663 -2.67212 +99 1 7.64597 6.8087 0.792436 6.14337 0.285334 5.54838 +100 1 6.81299 7.61529 0.784654 1.50923 3.73377 2.87701 +101 1 0.039157 8.46192 1.76149 -3.85041 1.88762 -2.12951 +102 1 0.799188 0.819633 1.69376 4.21763 0.723161 -3.63495 +103 1 0.763005 0.0408753 2.55669 11.5628 -1.30287 -1.53659 +104 1 0.0652633 0.934891 2.49039 -5.1145 -1.67274 5.33691 +105 1 1.66381 8.45402 1.66249 1.87623 5.22247 1.17986 +106 1 2.503 0.802578 1.65731 0.0918423 3.77669 3.70231 +107 1 2.51579 0.0135642 2.53917 0.463256 0.0266605 -0.815012 +108 1 1.65685 0.926197 2.57259 5.9178 -9.1905 -0.306187 +109 1 3.4242 0.0443963 1.67808 1.33331 -0.794171 2.32841 +110 1 4.23298 0.877511 1.6619 2.15651 0.36791 0.599305 +111 1 4.23114 8.48221 2.59613 0.139704 5.19667 3.26797 +112 1 3.42382 0.825355 2.52764 0.831325 -0.597344 0.750298 +113 1 5.10755 0.098598 1.64667 1.13835 -0.15217 0.418453 +114 1 6.07979 0.861483 1.66377 -9.38879 -3.1028 5.61252 +115 1 6.06362 0.0403691 2.64895 -6.98521 -8.98289 -11.9164 +116 1 5.20913 0.939312 2.59362 -1.28414 -1.16831 -2.67638 +117 1 6.75529 8.52816 1.79359 4.36806 -0.709446 -4.01445 +118 1 7.76101 0.764033 1.62558 -1.73868 3.93794 4.49945 +119 1 7.66206 0.0708021 2.53607 1.47505 -2.32899 1.29594 +120 1 6.92286 0.947435 2.52138 -4.88314 -16.5943 7.22153 +121 1 8.51449 1.72985 1.71942 6.76951 -3.05423 -0.995536 +122 1 0.834691 2.62553 1.61171 16.0236 -0.437826 23.4167 +123 1 0.945534 1.71145 2.53519 -17.6422 5.766 10.6769 +124 1 8.53575 2.60321 2.48391 2.61084 -9.58061 10.2444 +125 1 1.63294 1.72028 1.76938 14.1815 -0.440268 -11.5313 +126 1 2.57682 2.65502 1.67415 2.8611 -15.9615 10.724 +127 1 2.65189 1.65955 2.48962 -4.47742 1.085 2.58429 +128 1 1.79145 2.49644 2.55538 0.0425348 2.96537 1.56716 +129 1 3.45687 1.73281 1.73911 -3.75938 -0.279924 -8.91417 +130 1 4.34908 2.51749 1.7514 -3.12574 5.69408 -7.34516 +131 1 4.21985 1.73239 2.48294 4.56177 -5.44217 8.83153 +132 1 3.39941 2.5984 2.48766 0.0932155 -0.49927 3.02478 +133 1 5.22539 1.80308 1.7328 -5.21779 -2.43895 2.23844 +134 1 6.07426 2.60134 1.71356 -9.82102 -9.11759 6.53349 +135 1 6.06098 1.72463 2.48049 -24.0059 1.32147 25.9525 +136 1 5.04217 2.48583 2.60699 6.13261 3.37855 2.31458 +137 1 6.77443 1.68358 1.80416 26.2694 11.8834 -33.3324 +138 1 7.78345 2.52468 1.65191 -10.0717 7.23238 6.81167 +139 1 7.67217 1.70427 2.51662 7.38759 5.50979 0.483479 +140 1 6.87655 2.54802 2.65887 0.828003 6.30102 -11.6733 +141 1 8.48905 3.38009 1.79052 3.95862 11.358 -4.16794 +142 1 0.904648 4.31805 1.73458 -1.64595 0.0791848 -3.59387 +143 1 0.882159 3.48871 2.5578 -1.47386 -2.40831 0.515883 +144 1 0.0640856 4.36164 2.51005 -1.54232 -2.6948 -1.06039 +145 1 1.78366 3.38548 1.78248 -8.79706 -1.19951 -6.15917 +146 1 2.61647 4.18826 1.75601 -13.6767 13.2656 0.0962066 +147 1 2.49967 3.46972 2.59724 11.287 -7.88562 -0.187146 +148 1 1.72994 4.21494 2.4741 -1.76295 10.5241 6.69302 +149 1 3.35408 3.46945 1.74549 12.0923 -11.3982 2.63093 +150 1 4.33371 4.2573 1.65266 -1.0572 -0.0681575 -0.357999 +151 1 4.25135 3.37501 2.62082 -0.724851 2.23609 -3.08367 +152 1 3.37046 4.34755 2.6064 0.218455 -8.01846 -3.14612 +153 1 5.16664 3.3978 1.80383 -2.26051 -2.46633 -4.30603 +154 1 6.02075 4.21565 1.63908 -0.444656 2.88859 -0.464916 +155 1 6.04443 3.46025 2.46975 -2.50911 -3.21487 7.82311 +156 1 5.06457 4.21348 2.57808 1.01082 5.99339 -2.31274 +157 1 6.80721 3.3694 1.6818 12.0846 7.00158 1.77966 +158 1 7.66426 4.31037 1.75089 1.93845 -1.12426 -1.15071 +159 1 7.67666 3.35746 2.66226 0.0349977 1.35377 -1.51011 +160 1 6.86746 4.18845 2.58559 1.34212 2.76274 1.29577 +161 1 0.0121787 5.21746 1.67805 -1.66136 -3.05338 2.49187 +162 1 0.848043 6.06063 1.634 -1.152 -1.54074 2.03353 +163 1 0.891535 5.1714 2.53903 -1.80088 0.0367987 2.5043 +164 1 8.53141 6.02479 2.48115 1.46529 0.600203 2.28151 +165 1 1.67096 5.18637 1.75513 2.90335 -0.353263 -4.03581 +166 1 2.63344 6.0279 1.70432 -16.3644 -8.57778 -6.55322 +167 1 2.48532 5.10477 2.59913 0.462017 -0.718364 -1.79537 +168 1 1.74617 5.95248 2.59859 0.0442724 3.34654 -0.327538 +169 1 3.3871 5.11741 1.76498 -0.70902 0.100622 -1.55997 +170 1 4.23897 5.91622 1.65627 3.82091 1.24022 3.5679 +171 1 4.18272 5.19526 2.64844 4.07887 -0.154168 -2.99301 +172 1 3.33243 6.04257 2.48749 13.2178 -9.29314 8.76503 +173 1 5.21355 5.13048 1.6694 -5.38913 -0.724028 1.81762 +174 1 5.88731 6.04999 1.61164 27.08 -23.484 7.87668 +175 1 5.91685 5.19555 2.55373 8.22272 -5.32197 -1.91553 +176 1 5.22513 6.01752 2.48789 -6.37641 3.03262 4.81469 +177 1 6.87923 5.14396 1.75241 -1.31228 -0.52571 -0.175031 +178 1 7.66325 6.00346 1.75398 1.55065 0.721262 -1.56625 +179 1 7.71088 5.21107 2.64045 -0.197441 -3.63935 -3.47269 +180 1 6.81367 6.03163 2.50271 -0.887486 -5.65654 8.47366 +181 1 8.45469 6.86312 1.68381 5.32955 -1.93357 -1.0964 +182 1 0.887234 7.64699 1.70441 -8.03342 4.67955 6.65869 +183 1 0.827773 6.84361 2.49826 0.666014 -0.927683 2.41577 +184 1 0.0243326 7.6531 2.64337 -2.41729 -1.59288 -7.26092 +185 1 1.67566 6.82407 1.70759 6.3287 0.149047 4.42322 +186 1 2.51454 7.65687 1.63227 -3.24159 2.2536 7.24906 +187 1 2.61047 6.80534 2.59521 -8.48569 7.62473 -2.75927 +188 1 1.62469 7.75189 2.55083 1.70283 -3.32336 -0.400725 +189 1 3.32845 6.81114 1.68061 10.3844 9.25335 0.5217 +190 1 4.35781 7.7751 1.79868 -7.49989 -3.23754 -13.7369 +191 1 4.19243 6.92819 2.60428 15.2501 -13.591 -1.36339 +192 1 3.43706 7.60555 2.52571 -13.7857 14.6138 -0.968483 +193 1 5.20185 6.77695 1.66316 -21.9331 19.6829 3.32007 +194 1 5.90138 7.62608 1.77842 3.59956 5.50204 -2.20333 +195 1 5.95566 6.93899 2.64467 1.5684 -14.0837 -9.48217 +196 1 5.06902 7.62841 2.55428 6.74225 1.46675 8.63059 +197 1 6.76742 6.8085 1.78801 1.36869 6.36826 -6.59728 +198 1 7.65843 7.62584 1.68675 -2.22178 4.8322 -2.62428 +199 1 7.67415 6.89867 2.52463 2.21143 -5.15334 3.5596 +200 1 6.87662 7.66202 2.55284 -3.26152 2.73313 1.32325 +201 1 0.0405641 8.51038 3.32948 -5.92557 3.54592 8.59039 +202 1 0.809165 0.908392 3.38948 1.71953 -1.70344 0.923667 +203 1 0.901714 8.46653 4.19384 -9.71216 4.93867 8.34322 +204 1 0.069999 0.928448 4.31429 -4.27362 -2.53344 -6.14786 +205 1 1.6264 8.4509 3.42354 8.98155 6.03203 -6.76996 +206 1 2.65602 0.762944 3.43842 -5.54094 5.64927 -11.0802 +207 1 2.61793 0.0468587 4.22961 -1.55064 -6.54911 6.6458 +208 1 1.68094 0.888048 4.32275 0.711784 -4.72688 -3.71581 +209 1 3.43429 8.45723 3.40115 7.64008 12.4108 0.619842 +210 1 4.23416 0.880739 3.42582 5.39503 -6.32873 -0.402512 +211 1 4.18642 8.4609 4.33191 11.6244 16.7018 2.29066 +212 1 3.36155 0.898574 4.22656 4.93072 -1.64922 5.55995 +213 1 5.13206 0.0787666 3.45034 -0.945527 -3.11163 -2.8253 +214 1 6.05542 0.815095 3.33818 0.680768 11.3265 10.7561 +215 1 5.88615 0.068379 4.32153 11.9175 -9.57172 -8.45948 +216 1 5.21525 0.885851 4.19789 -5.15816 5.54694 4.34946 +217 1 6.80589 8.45257 3.40423 5.88256 0.0541198 6.21084 +218 1 7.74454 0.870555 3.46229 0.501904 -4.05279 -5.44709 +219 1 7.62711 0.0144156 4.35804 1.95636 -0.757148 -6.431 +220 1 6.7475 0.756319 4.34542 2.82117 3.60456 -0.442947 +221 1 0.046471 1.74765 3.48426 -2.94726 0.460616 -2.28233 +222 1 0.888532 2.54472 3.37968 0.966992 1.17998 0.546373 +223 1 0.832134 1.79852 4.28422 5.1168 -14.8036 -11.8055 +224 1 0.0855384 2.60849 4.37243 -9.37894 3.13224 -11.0091 +225 1 1.76053 1.64213 3.45381 -3.40447 2.71972 -2.85028 +226 1 2.52635 2.61582 3.43297 3.65437 -1.51294 -3.08517 +227 1 2.50122 1.75788 4.25552 8.72555 -0.689386 -1.86072 +228 1 1.75205 2.6278 4.21833 -8.89154 -5.54607 2.69229 +229 1 3.50205 1.65486 3.36684 -7.50491 6.39615 -0.836562 +230 1 4.28152 2.60594 3.4252 -1.76945 -2.76432 2.53661 +231 1 4.17705 1.67239 4.28707 6.76533 -1.25356 -1.29705 +232 1 3.44438 2.47178 4.25656 -4.81944 5.002 -0.576402 +233 1 5.22486 1.68937 3.43619 -3.28026 2.78772 -4.39101 +234 1 6.02069 2.55292 3.33778 -3.72236 0.507942 3.01424 +235 1 5.96152 1.77008 4.23889 4.98563 -0.248026 3.40967 +236 1 5.17107 2.61009 4.24734 -0.598251 0.473097 -0.376582 +237 1 6.87337 1.72985 3.32607 -2.78397 -6.76638 7.83701 +238 1 7.692 2.50127 3.44714 2.52098 2.71173 -0.194497 +239 1 7.63531 1.64894 4.19535 0.881487 3.19892 6.53537 +240 1 6.92924 2.5559 4.32195 -3.68781 1.74243 -2.92343 +241 1 0.0154582 3.42553 3.38818 0.573657 0.250438 1.11994 +242 1 0.946668 4.34133 3.49534 -14.1263 -16.7645 -9.90419 +243 1 0.911751 3.43019 4.31621 -0.850264 0.755291 -1.68921 +244 1 0.0046042 4.25775 4.34424 -1.31738 -1.24756 -1.54253 +245 1 1.76086 3.48229 3.3966 -12.418 -8.98763 3.21891 +246 1 2.48605 4.22978 3.40508 14.0841 10.3397 -4.15997 +247 1 2.54799 3.33831 4.30225 4.92033 13.8543 -7.00111 +248 1 1.7676 4.3622 4.17566 0.280546 -16.6448 26.3844 +249 1 3.37038 3.45998 3.42173 -0.200746 -1.45028 -1.29578 +250 1 4.20874 4.30541 3.50172 4.65367 -11.48 -19.1828 +251 1 4.21154 3.43635 4.23457 4.19917 -3.40534 2.03948 +252 1 3.45806 4.23712 4.25878 -8.55751 2.75292 6.08306 +253 1 5.11168 3.47839 3.3691 -0.311412 -5.69502 5.70804 +254 1 5.92148 4.26406 3.41002 5.13821 -1.04796 0.0327238 +255 1 6.02264 3.46008 4.23226 -3.02748 -3.55814 1.41554 +256 1 5.17114 4.24863 4.35423 -2.77791 4.93248 -13.0008 +257 1 6.86557 3.34851 3.50434 -4.54964 -0.0741147 -9.06001 +258 1 7.67607 4.29403 3.50495 4.02814 6.65377 -10.7943 +259 1 7.67432 3.49417 4.17544 8.6417 -11.3672 14.2425 +260 1 6.8466 4.22166 4.23144 -3.46256 4.46394 4.938 +261 1 0.0814499 5.05812 3.37338 -2.94602 3.43381 2.0972 +262 1 0.952662 5.9924 3.43554 -2.60446 0.4469 0.54362 +263 1 0.765082 5.07607 4.26673 5.31334 4.0071 5.5605 +264 1 0.0672914 5.95184 4.29838 -1.77164 3.23629 -2.96482 +265 1 1.64676 5.09677 3.49021 9.45599 25.7387 -15.7709 +266 1 2.59524 6.06011 3.441 -1.69946 -11.0916 -4.14222 +267 1 2.46878 5.21999 4.3176 5.41184 -22.6386 -22.4739 +268 1 1.72435 5.99765 4.33067 -8.961 3.18884 -2.81076 +269 1 3.33576 5.13502 3.32819 -1.95672 4.97188 10.3591 +270 1 4.33219 6.01601 3.4905 -3.43576 -1.4684 -1.43775 +271 1 4.2868 5.05318 4.19611 2.54498 12.874 12.0539 +272 1 3.47487 5.92769 4.31716 -1.095 0.823289 -0.856965 +273 1 5.22135 5.10776 3.40172 -8.93936 2.06172 1.30023 +274 1 6.0405 5.92456 3.43523 0.724841 2.24513 0.144002 +275 1 5.92006 5.1314 4.26005 8.25611 -3.42587 -2.20917 +276 1 5.11155 5.91401 4.29084 1.00396 1.28478 -0.181662 +277 1 6.86476 5.07118 3.47111 -5.70253 1.83988 -3.65428 +278 1 7.60709 5.97166 3.43329 1.57958 3.02153 1.22094 +279 1 7.62121 5.17116 4.25108 13.415 -9.76593 -1.32536 +280 1 6.90725 5.93696 4.35438 -12.0061 10.5099 -5.89092 +281 1 0.0158532 6.88433 3.5005 2.50125 -3.66413 -3.15884 +282 1 0.832759 7.6858 3.39159 0.810583 -3.83454 1.16734 +283 1 0.879361 6.87893 4.25184 1.06811 -4.80567 -3.71366 +284 1 8.48025 7.67569 4.32838 6.71448 4.3067 1.89144 +285 1 1.76699 6.83608 3.37875 -3.92913 2.06189 -0.762911 +286 1 2.64337 7.79272 3.38564 -11.5742 -11.6301 0.504133 +287 1 2.51611 6.79594 4.20547 2.9771 6.7763 8.40555 +288 1 1.73472 7.75634 4.30153 3.5376 -4.65751 1.06495 +289 1 3.42458 6.78486 3.36363 0.711862 2.92454 6.30952 +290 1 4.29146 7.78029 3.51531 3.92856 -8.43358 -6.61451 +291 1 4.22796 6.89496 4.356 2.49253 -3.58746 -4.19183 +292 1 3.49073 7.69895 4.31251 -15.4332 -7.21194 0.0843114 +293 1 5.03295 6.88949 3.43613 2.4132 0.715094 1.20127 +294 1 5.9914 7.60738 3.43115 0.166605 10.2994 10.8333 +295 1 6.06057 6.76316 4.28526 -0.682389 0.774521 0.518315 +296 1 5.1506 7.68481 4.35956 -0.587179 -0.831286 -4.17718 +297 1 6.91829 6.87557 3.41173 -2.20287 0.087574 0.74732 +298 1 7.77376 7.66664 3.47631 -5.20912 2.94829 -3.10686 +299 1 7.7733 6.85147 4.2793 -6.28798 -5.26886 2.97867 +300 1 6.79627 7.70864 4.34123 1.13479 0.471756 -2.41754 +301 1 8.47537 0.0666715 5.07785 3.07732 -2.35936 2.36099 +302 1 0.837862 0.824189 5.08442 2.67015 -0.0526079 4.2528 +303 1 0.947354 8.53746 5.97515 -9.44477 -2.06512 3.38353 +304 1 8.45527 0.903487 5.90211 4.35699 -8.49334 13.6006 +305 1 1.71466 0.0614796 5.21675 1.71751 -10.7388 -14.8483 +306 1 2.56545 0.785351 5.1483 1.0332 2.19745 -1.75997 +307 1 2.58448 8.48208 5.91956 0.430753 0.76971 3.58164 +308 1 1.65003 0.816215 5.93197 3.03102 12.7849 8.36083 +309 1 3.46033 0.0141985 5.16494 -4.25366 -0.783326 -0.484155 +310 1 4.20213 0.929517 5.13838 2.42665 -3.78185 -0.152962 +311 1 4.26733 0.0836521 5.92638 3.25998 -1.091 1.74874 +312 1 3.41102 0.861262 6.03148 -0.949591 0.0559607 -1.66554 +313 1 5.1564 8.53616 5.06672 -11.5945 -0.673098 9.37255 +314 1 5.94115 0.761043 5.20173 4.62182 33.122 -29.3364 +315 1 5.93463 0.0696556 5.8868 1.75697 -30.8547 30.3151 +316 1 5.14065 0.9256 5.95741 -0.006185 -4.789 2.4932 +317 1 6.91953 8.50208 5.18386 -10.6338 4.52372 2.129 +318 1 7.72317 0.898909 5.10883 -6.55365 -0.206627 -4.30053 +319 1 7.67728 0.0288812 5.99182 2.50541 0.776267 0.642418 +320 1 6.91834 0.891409 5.91811 -4.13582 -0.84176 -0.41985 +321 1 0.0355634 1.62397 5.15959 0.786537 13.0999 -7.10363 +322 1 0.855042 2.4658 5.05819 10.8208 10.8619 21.426 +323 1 0.798893 1.71459 6.01685 5.79471 -4.43182 -0.915803 +324 1 0.0659206 2.49237 5.91102 -5.57064 6.4328 0.916789 +325 1 1.77633 1.69788 5.04117 -5.55508 3.43302 7.46453 +326 1 2.55086 2.64298 5.08873 0.0193134 -8.77259 6.85672 +327 1 2.49765 1.63315 5.92814 1.12021 1.50275 1.88199 +328 1 1.80539 2.621 5.95731 -6.21714 -3.35524 -0.269961 +329 1 3.34329 1.63256 5.07699 -2.20219 4.06192 2.43743 +330 1 4.31458 2.52073 5.06335 -0.0632538 1.3392 1.20942 +331 1 4.33916 1.68863 5.97126 -3.41941 3.44417 2.01134 +332 1 3.42212 2.64548 5.89276 -0.0280586 -2.67425 3.44656 +333 1 5.16333 1.72803 5.18363 0.62931 0.268233 -3.53629 +334 1 5.97493 2.53755 5.18126 5.42417 -2.99996 -10.5798 +335 1 5.97644 1.77632 6.05208 2.30795 -0.932212 -2.38345 +336 1 5.20771 2.64035 5.9206 -9.19429 -1.91265 5.67918 +337 1 6.82113 1.7288 5.07227 0.319047 -2.27809 2.42075 +338 1 7.76584 2.66005 5.04767 0.36372 -2.98667 3.98468 +339 1 7.68048 1.73285 5.98682 1.83082 2.55026 -3.35109 +340 1 6.77723 2.66049 6.0628 11.9195 -28.0419 -0.192401 +341 1 8.52926 3.48894 5.20725 0.756027 -4.20422 -2.12394 +342 1 0.880496 4.18659 5.21886 -2.21024 5.88812 -5.98946 +343 1 0.823278 3.46696 6.03218 3.03891 -2.5906 1.31712 +344 1 8.45604 4.28238 5.97679 3.43734 -0.298701 2.3281 +345 1 1.66848 3.43018 5.1681 4.45896 -2.65722 -0.776378 +346 1 2.47623 4.29797 5.21376 10.0204 -9.1421 -8.64412 +347 1 2.46945 3.49538 6.0664 15.3766 -12.245 -4.5397 +348 1 1.75883 4.22715 6.00615 -17.7933 12.7993 4.23364 +349 1 3.32535 3.48763 5.18919 1.16348 3.11251 -2.54898 +350 1 4.29953 4.30461 5.21296 -7.48003 6.57243 -13.8987 +351 1 4.32836 3.50006 5.90127 -9.25916 -18.9556 4.88449 +352 1 3.45987 4.23872 6.06433 -4.26661 1.09432 -3.11516 +353 1 5.16317 3.46797 5.05136 -2.20358 -10.3645 8.38524 +354 1 6.01128 4.18674 5.11415 3.72823 2.851 1.21774 +355 1 6.05124 3.32995 5.89897 -17.0823 24.7049 3.10753 +356 1 5.05098 4.23901 5.94533 18.4684 10.5132 6.34816 +357 1 6.93195 3.37363 5.21832 -12.1973 3.61502 -16.8233 +358 1 7.67472 4.24466 5.1448 -0.046387 1.44369 -2.14451 +359 1 7.59877 3.3598 5.99617 16.3705 11.4653 3.48987 +360 1 6.9163 4.33093 6.01136 -0.884888 -0.827495 0.436994 +361 1 8.47485 5.1618 5.06757 4.58611 -6.95556 3.64111 +362 1 0.866551 5.92561 5.22826 -2.4458 0.731452 -4.83922 +363 1 0.856029 5.03088 5.93872 -0.961264 1.16585 2.50638 +364 1 0.025531 6.08363 6.03301 -0.603503 -3.86392 0.433571 +365 1 1.73882 5.05771 5.16436 -7.87894 6.49017 -0.085231 +366 1 2.54586 5.89415 5.04217 4.79689 21.4637 24.3945 +367 1 2.63875 5.11717 5.9033 -10.4096 0.222879 12.4433 +368 1 1.7282 6.02787 5.89482 3.82714 -3.17245 6.07309 +369 1 3.41343 5.11888 5.19776 7.89672 -3.25441 -9.4893 +370 1 4.34849 6.08405 5.13729 -6.43313 -7.37614 1.57014 +371 1 4.30919 5.18003 6.06007 -0.523489 -1.53897 -0.492658 +372 1 3.32135 5.97978 5.88753 6.80953 0.93257 3.29984 +373 1 5.2281 5.04347 5.09516 -5.81719 1.07839 6.76004 +374 1 5.94602 5.8851 5.09539 3.02249 4.44225 2.10278 +375 1 6.04092 5.17575 6.07061 0.50428 -9.39491 -12.3653 +376 1 5.21437 6.06631 6.06016 -6.35945 -8.11006 -13.4627 +377 1 6.91579 5.12007 5.08308 -5.11836 -4.49572 6.409 +378 1 7.70983 5.91053 5.07808 1.5309 9.32926 6.58643 +379 1 7.76683 5.15653 6.01534 -1.66429 -5.18049 -8.59085 +380 1 6.93784 6.03915 5.96221 -25.2768 -19.3137 -6.75792 +381 1 0.0625638 6.74931 5.10819 -0.676634 2.54846 -0.0250987 +382 1 0.86361 7.61298 5.03345 -2.5044 7.0388 6.38474 +383 1 0.851706 6.88156 6.03092 0.201379 -3.97494 -1.33706 +384 1 0.0506067 7.6425 5.89338 -1.769 2.22377 0.622415 +385 1 1.66322 6.86583 5.19561 3.09287 -3.33398 -7.05581 +386 1 2.62799 7.62451 5.17609 -27.9662 28.0267 -4.59006 +387 1 2.66202 6.83135 5.96842 -24.8289 -0.817724 19.495 +388 1 1.64735 7.66733 5.92394 4.49398 5.54382 1.70924 +389 1 3.32274 6.93842 5.22499 45.6897 -26.2601 -20.0997 +390 1 4.28266 7.68312 5.1494 -0.162983 0.307259 3.3477 +391 1 4.21122 6.74188 6.04596 -0.795282 5.66715 -3.63702 +392 1 3.40786 7.67271 6.05784 2.18013 1.35082 -0.335047 +393 1 5.13386 6.80127 5.05013 6.80473 4.27889 3.23937 +394 1 6.0188 7.62146 5.18796 -3.27693 10.2601 -11.1928 +395 1 5.9142 6.93974 5.96821 7.16288 -22.7812 5.828 +396 1 5.1207 7.60724 5.96887 -13.0365 8.36981 -2.80723 +397 1 6.90344 6.91817 5.14994 -0.204819 -5.34708 -0.858742 +398 1 7.6747 7.73724 5.15589 4.74286 -4.17129 0.509029 +399 1 7.64232 6.7419 6.03772 18.4896 23.5989 -0.89996 +400 1 6.75496 7.62762 6.01659 7.03025 5.11039 1.24431 +401 1 0.0963896 0.0201086 6.80553 -1.40648 -0.449972 0.0493894 +402 1 0.835843 0.891839 6.79877 7.20248 -7.32555 0.745706 +403 1 0.918901 8.53581 7.64787 -17.0565 2.54879 17.4592 +404 1 0.0577403 0.896342 7.73471 1.30728 -4.31515 -1.61795 +405 1 1.61051 8.45024 6.92242 29.7484 14.9171 -14.6755 +406 1 2.47578 0.885204 6.88627 1.39053 -1.86497 -2.40181 +407 1 2.50444 0.0274811 7.76899 5.04636 2.83552 -7.66004 +408 1 1.76075 0.832954 7.77629 -9.26653 -0.311946 -7.26081 +409 1 3.50837 8.51457 6.78791 -7.98313 -6.7176 0.868776 +410 1 4.17648 0.757665 6.93195 8.57719 11.9693 -2.56623 +411 1 4.23832 0.0657272 7.77237 -2.00114 -7.83956 -8.62893 +412 1 3.37339 0.86481 7.76894 -4.57993 4.49098 -10.8865 +413 1 5.14407 0.0592801 6.76072 -1.57797 -1.16589 1.03837 +414 1 5.93853 0.879814 6.88423 6.63031 -4.29327 -1.40131 +415 1 6.03919 8.48714 7.63222 -2.96915 1.1039 1.2166 +416 1 5.15255 0.794385 7.73799 -0.425319 2.1861 -1.28188 +417 1 6.89313 0.0918814 6.89086 -1.49841 -3.77335 -3.98868 +418 1 7.61212 0.939213 6.80354 8.77263 -4.1407 2.30253 +419 1 7.70899 8.53849 7.72172 -1.01623 -1.03696 -1.75272 +420 1 6.83169 0.853131 7.69229 0.514071 1.96118 2.47006 +421 1 0.0995377 1.63996 6.92907 -20.9698 6.48021 -16.3567 +422 1 0.856061 2.59196 6.8009 3.6314 -4.45866 -1.95318 +423 1 0.7986 1.79168 7.64825 21.262 -5.45904 12.6361 +424 1 0.086833 2.5674 7.63497 -11.6486 2.30739 1.5806 +425 1 1.65946 1.72494 6.90853 -2.96091 -3.71884 -7.8878 +426 1 2.55175 2.62076 6.77199 1.34599 -1.3093 4.14575 +427 1 2.49264 1.73911 7.61263 5.68035 -0.198489 5.50404 +428 1 1.73023 2.55227 7.60126 -2.61513 6.16936 5.4644 +429 1 3.34887 1.7831 6.78557 0.7181 -0.718938 0.35045 +430 1 4.23104 2.60662 6.78869 6.67274 -5.2978 -0.800832 +431 1 4.35855 1.74494 7.60411 -4.34125 -3.35913 2.62052 +432 1 3.36542 2.60589 7.78048 1.27821 -1.57097 -4.57229 +433 1 5.20004 1.65594 6.83168 -6.03666 5.50106 2.07188 +434 1 5.95504 2.56783 6.93549 0.704503 2.20695 -11.5481 +435 1 6.05448 1.73837 7.6627 -1.83376 -2.83098 2.15288 +436 1 5.1146 2.5438 7.6124 2.3372 -0.290906 4.36925 +437 1 6.88113 1.721 6.77631 -7.16431 5.43568 2.84999 +438 1 7.667 2.62761 6.74793 2.83097 -7.51196 9.4855 +439 1 7.73348 1.72515 7.754 -4.1563 0.657477 -6.03723 +440 1 6.7624 2.63316 7.64937 6.65302 -0.565372 4.94425 +441 1 0.0849859 3.37793 6.84942 -10.0386 4.11872 -3.53604 +442 1 0.857904 4.2895 6.93068 1.24699 0.504054 -2.41984 +443 1 0.822866 3.35005 7.62376 7.62204 5.76535 8.89189 +444 1 0.0609986 4.27823 7.72873 -1.62474 0.278416 -2.41968 +445 1 1.65771 3.45598 6.89789 2.67743 0.0202624 -2.34558 +446 1 2.54508 4.23374 6.86348 0.989961 3.94158 3.39783 +447 1 2.51344 3.50821 7.77131 2.79285 -8.19104 -6.06353 +448 1 1.76675 4.31871 7.74484 -7.62178 -3.47349 -5.94274 +449 1 3.46999 3.3444 6.87805 -6.49672 7.19856 -0.129806 +450 1 4.27761 4.20284 6.7963 2.00695 2.57497 4.55692 +451 1 4.36643 3.33193 7.71738 -5.18938 3.59254 -0.980407 +452 1 3.39117 4.21736 7.78484 2.56803 1.85612 -2.81745 +453 1 5.17851 3.50703 6.80054 -0.562057 -4.69817 1.35476 +454 1 5.91855 4.34694 6.82856 20.1656 -16.4219 -1.68121 +455 1 5.94421 3.41917 7.73472 -0.686701 1.44481 -0.413888 +456 1 5.21752 4.35256 7.70192 -2.57704 -7.73472 4.05334 +457 1 6.81349 3.41173 6.82265 -1.40277 6.3135 5.01717 +458 1 7.75813 4.35693 6.90395 -1.64702 -1.61669 -0.476323 +459 1 7.7614 3.35066 7.72289 -1.59004 1.58238 -2.0122 +460 1 6.90386 4.19648 7.73719 0.143217 3.47184 -3.3084 +461 1 8.51568 5.21538 6.91302 4.27065 -2.85002 -1.50895 +462 1 0.951652 6.01174 6.9207 -11.7991 -7.13131 -18.8927 +463 1 0.936182 5.16144 7.77632 -7.30596 -5.41004 -9.74737 +464 1 0.00163562 6.07485 7.63199 0.624183 -4.07361 5.99132 +465 1 1.66533 5.15284 6.74597 2.96466 -1.56742 2.06772 +466 1 2.61909 5.93515 6.89385 -1.40662 1.18192 -1.24787 +467 1 2.46927 5.13962 7.72554 6.76967 2.2802 -3.81441 +468 1 1.64453 6.02831 7.68681 19.7677 -7.24739 11.5441 +469 1 3.40343 5.06011 6.8889 -0.198511 0.401262 -0.796323 +470 1 4.30752 6.01937 6.85588 -10.789 -11.9311 3.49788 +471 1 4.28416 5.14222 7.62835 0.609452 -0.263512 0.8346 +472 1 3.47645 6.07368 7.70428 -7.22384 -10.7657 -0.906726 +473 1 5.22078 5.0656 6.90915 -18.0053 20.6161 -6.39 +474 1 5.99499 5.93089 6.77083 3.48021 13.0571 15.6598 +475 1 6.05342 5.21794 7.69617 -5.52282 -4.0969 2.40523 +476 1 5.15908 5.93838 7.59985 0.288818 1.34614 5.01043 +477 1 6.82844 5.21514 6.92244 2.6589 -10.3439 -6.80084 +478 1 7.65444 5.90306 6.73997 5.39846 9.09532 17.1635 +479 1 7.73871 5.1328 7.74827 -11.0217 0.411956 -11.9718 +480 1 6.85057 5.9849 7.66627 -2.19779 2.18231 4.19621 +481 1 8.49223 6.85953 6.88515 0.63092 3.61848 -3.8326 +482 1 0.912061 7.72558 6.80554 -14.7372 -15.0451 -0.530208 +483 1 0.94972 6.80465 7.60047 -8.86666 17.9559 7.11774 +484 1 0.0485157 7.69847 7.76952 0.871021 -3.29928 -3.01128 +485 1 1.7395 6.92207 6.74618 -0.216972 -4.99493 2.92958 +486 1 2.48517 7.73307 6.85664 4.02861 0.442708 -0.186237 +487 1 2.60224 6.86957 7.70226 -2.68029 -0.280597 -1.3011 +488 1 1.75659 7.71058 7.78997 -12.217 -12.015 -24.8657 +489 1 3.36601 6.81921 6.83807 2.83617 1.11452 1.50668 +490 1 4.30578 7.6333 6.9198 -11.3388 0.787746 -11.6868 +491 1 4.17656 6.84912 7.75346 9.62737 7.65922 -1.79281 +492 1 3.37828 7.72239 7.62462 0.544776 0.263736 1.68806 +493 1 5.03666 6.75188 6.83201 10.5371 18.8221 7.02157 +494 1 5.88561 7.69892 6.74579 2.44744 2.75196 7.83 +495 1 6.02886 6.89217 7.71335 -1.94107 -2.07696 0.28038 +496 1 5.05253 7.6432 7.63466 10.7152 0.484071 10.517 +497 1 6.76592 6.82276 6.85512 1.71624 -1.12004 -2.46021 +498 1 7.63682 7.73046 6.77254 1.37903 -1.27982 -0.239663 +499 1 7.60482 6.74157 7.76697 8.04118 12.5638 -12.9988 +500 1 6.86424 7.69163 7.60229 0.0588858 0.119654 2.66424 +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +500 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 8.2207069144348992e+00 +0.0000000000000000e+00 8.2207069144348992e+00 +0.0000000000000000e+00 8.2207069144348992e+00 +ITEM: ATOMS id type x y z f_1[1] f_1[2] f_1[3] +1 1 0.0109462 8.19276 8.15872 -2.39444 9.6729 7.55614 +2 1 0.913757 0.79291 0.0997863 -14.8553 6.06953 -19.2131 +3 1 0.922041 0.00329478 0.797424 -4.57303 -13.0314 3.29774 +4 1 0.0667547 0.768895 0.898382 -4.60646 8.57627 -8.38591 +5 1 1.74036 8.13245 0.0766359 -17.8989 17.5469 -5.09772 +6 1 2.47269 0.889925 0.0248853 -5.42566 -21.0007 -17.6291 +7 1 2.46322 8.1233 0.872599 4.75898 11.1097 -4.77186 +8 1 1.65846 0.837491 0.791152 15.1363 -5.40511 14.9864 +9 1 3.32881 8.19546 0.053156 -13.3342 -9.93994 -9.94684 +10 1 4.03279 0.760382 0.00184897 9.91793 7.67217 -5.53917 +11 1 4.13378 8.169 0.732239 -0.574085 -2.22965 11.4349 +12 1 3.20922 0.774467 0.746193 11.6707 -5.4973 20.7036 +13 1 4.84922 8.194 8.14339 7.30804 6.79019 8.16024 +14 1 5.8218 0.772541 8.17358 -10.0231 -1.2549 7.34514 +15 1 5.68256 8.16785 0.77714 3.02512 1.45358 -0.272422 +16 1 4.85759 0.84201 0.746179 4.61671 -0.701957 -1.77598 +17 1 6.62546 8.16087 8.21828 -7.1959 6.90651 13.7327 +18 1 7.47259 0.88807 0.0569708 -4.40901 -2.93179 -3.05075 +19 1 7.47431 0.0411346 0.771198 -11.1102 -3.58532 -4.76152 +20 1 6.57656 0.847149 0.913044 26.339 -17.4997 -36.7448 +21 1 8.18759 1.70398 8.18761 4.1072 -0.492398 0.811998 +22 1 0.899666 2.41042 8.17073 -11.5274 -4.75425 3.68191 +23 1 0.850302 1.72005 0.839978 5.34352 -14.6759 -1.78579 +24 1 0.0603398 2.39798 0.844681 -8.60658 17.5352 -6.64359 +25 1 1.71223 1.59237 0.0242378 -11.0164 14.7761 -6.28233 +26 1 2.39934 2.5183 0.00540478 8.02997 -3.83137 6.03634 +27 1 2.48112 1.56604 0.834626 2.61805 16.1266 0.364368 +28 1 1.6143 2.50502 0.831093 22.9512 -23.9291 -18.4162 +29 1 3.30714 1.5456 0.0352888 3.02185 20.9324 -4.02492 +30 1 4.17998 2.44319 8.21567 -15.5858 -1.30182 -5.2994 +31 1 4.13571 1.72982 0.900024 -11.4398 -17.9409 -9.12775 +32 1 3.31093 2.54257 0.820203 -10.3368 -11.5392 -3.6507 +33 1 5.0044 1.71067 8.16991 -2.52586 -20.2729 12.2321 +34 1 5.83707 2.42978 0.0552544 -9.07217 4.33101 -1.43054 +35 1 5.68958 1.61323 0.87339 20.6627 3.79367 -24.2404 +36 1 4.88712 2.41203 0.783075 18.227 14.4306 8.63131 +37 1 6.51234 1.55641 0.0925838 9.00513 9.77167 -3.15357 +38 1 7.38894 2.55021 8.21638 -3.89162 -5.39246 1.97695 +39 1 7.3932 1.68143 0.910549 14.6159 -16.4356 -32.9418 +40 1 6.52029 2.5195 0.875176 1.21021 -6.27577 -1.18313 +41 1 0.0178952 3.25358 8.17469 3.31384 23.2108 27.1434 +42 1 0.75874 4.10726 8.14569 6.02202 2.9315 8.91628 +43 1 0.895393 3.22207 0.752637 -27.1078 14.1691 0.641871 +44 1 8.18599 4.06691 0.900855 -0.259841 0.495686 -5.35481 +45 1 1.55285 3.22874 8.15747 6.98433 26.3863 8.64396 +46 1 2.49624 4.20319 8.19485 -11.6121 -5.75058 -7.87094 +47 1 2.42547 3.30302 0.888339 10.6882 -12.4594 -2.99107 +48 1 1.6862 4.0108 0.835279 -13.347 15.0654 -7.27246 +49 1 3.22 3.33904 0.0153378 4.70565 -17.4148 -11.2872 +50 1 4.15099 4.01359 0.0472035 -3.25232 -0.128895 -8.82814 +51 1 4.06799 3.24916 0.843927 9.3476 8.05351 2.04714 +52 1 3.19501 4.05 0.736238 12.2088 14.8797 22.981 +53 1 4.93359 3.21205 8.21538 5.02686 8.32666 2.39487 +54 1 5.81852 4.10681 0.0313505 -9.96067 16.6194 -8.35941 +55 1 5.78406 3.36669 0.776887 -2.74739 -9.47942 10.9149 +56 1 4.90983 4.0411 0.864362 0.837356 4.14382 -0.368312 +57 1 6.53897 3.36302 8.19911 9.90234 -20.173 11.5285 +58 1 7.46276 4.04697 0.0534703 -5.76424 1.73449 -3.50806 +59 1 7.34501 3.24442 0.827453 2.34892 5.8087 4.09531 +60 1 6.59021 4.15121 0.905225 -2.44603 -12.1461 -5.89568 +61 1 8.13258 4.93013 0.0905402 6.61239 1.0085 -5.83678 +62 1 0.918786 5.84938 8.18896 -100.34 -125.435 4.75603 +63 1 0.733666 4.90689 0.894865 5.0782 -1.1493 -19.9038 +64 1 8.13743 5.78012 0.885656 21.4143 -27.2006 -30.8387 +65 1 1.67225 4.91657 0.0765019 -6.36422 -5.41993 -9.68754 +66 1 2.43163 5.74665 8.16344 0.0454169 7.36314 0.282499 +67 1 2.52248 4.94902 0.779546 -17.0632 -3.92502 5.40756 +68 1 1.68817 5.73221 0.738326 -10.7061 -22.6586 25.0306 +69 1 3.20519 4.98792 8.20267 13.0471 -20.6699 18.764 +70 1 4.1645 5.8475 0.0144516 -41.0284 -51.2746 -22.2701 +71 1 4.12065 4.85332 0.726813 -6.7392 5.54296 9.04283 +72 1 3.22358 5.72978 0.902951 13.2902 6.38408 -11.6219 +73 1 4.86923 4.9681 8.18768 10.2044 -1.77915 -2.81852 +74 1 5.77301 5.70687 8.13281 -22.5863 16.9623 33.7246 +75 1 5.78731 4.97674 0.770243 -6.25016 -2.29075 -2.78772 +76 1 4.89256 5.78932 0.733037 29.9716 -43.8231 39.093 +77 1 6.61696 5.02048 8.19969 -11.3595 -28.891 -1.36328 +78 1 7.33645 5.74186 0.0277988 27.1444 12.1113 -11.7126 +79 1 7.32557 4.92161 0.798933 6.38759 1.63603 8.88722 +80 1 6.60198 5.76847 0.724174 -12.087 6.06842 22.1567 +81 1 0.0632305 6.4911 0.00261304 -6.53376 9.85675 7.22968 +82 1 0.730752 7.3973 8.19101 19.8665 -4.89129 14.6872 +83 1 0.894205 6.53954 0.906348 -15.672 -5.70878 -18.8817 +84 1 0.0916376 7.35116 0.914882 -39.3163 -12.8553 -54.9509 +85 1 1.54844 6.4779 0.0899714 109.204 121.919 -0.90408 +86 1 2.45374 7.43343 8.1677 17.1682 -16.9212 2.53497 +87 1 2.38485 6.48495 0.871503 16.8711 24.0952 -19.5071 +88 1 1.73482 7.30198 0.918245 -4.50526 25.4363 -21.6583 +89 1 3.35837 6.52948 0.00621289 -17.9347 4.05163 8.57797 +90 1 4.15544 7.30314 8.17418 -3.86421 14.3399 10.028 +91 1 4.18078 6.49797 0.807337 -33.0181 25.5019 29.3461 +92 1 3.28881 7.33369 0.840128 0.0678552 -0.60668 -1.16807 +93 1 4.86711 6.50097 0.0644243 55.2704 56.5162 -42.5456 +94 1 5.6807 7.37537 8.15497 2.37339 1.6253 6.06405 +95 1 5.83906 6.54647 0.813774 -8.31017 -0.439493 -0.862375 +96 1 4.90102 7.33548 0.785855 3.38301 3.17369 4.3776 +97 1 6.62594 6.60016 8.16507 -28.5529 -10.5165 29.461 +98 1 7.41236 7.32596 8.18119 12.8158 16.6867 22.5272 +99 1 7.48788 6.57526 0.906715 -17.6408 15.7915 -12.9219 +100 1 6.60846 7.32088 0.891813 -2.23221 1.45701 -6.99196 +101 1 8.17 8.13088 1.54543 21.7946 28.0076 23.7334 +102 1 0.889634 0.755106 1.5647 -2.22366 9.82139 12.4406 +103 1 0.787312 0.00367743 2.47285 9.7959 7.14049 -7.07183 +104 1 0.0399172 0.910289 2.54829 -10.4426 -54.7685 -48.8923 +105 1 1.70161 0.076186 1.70291 0.655659 -5.9987 -1.53887 +106 1 2.5425 0.840944 1.65312 -5.39214 -2.71573 1.42057 +107 1 2.39333 0.0846015 2.56412 19.1459 -13.6703 -26.8796 +108 1 1.62991 0.895915 2.55976 -9.37186 -8.23605 -42.2796 +109 1 3.3255 0.037006 1.60354 -4.30714 4.73223 -3.06839 +110 1 4.20236 0.841896 1.65063 -10.9567 4.39501 -2.76043 +111 1 4.12511 8.16508 2.38147 6.48597 31.2032 29.2026 +112 1 3.37125 0.822661 2.38548 -3.89508 0.169143 6.57094 +113 1 4.86677 0.028066 1.55007 9.3902 -7.55136 2.71818 +114 1 5.8528 0.805894 1.56988 -29.5994 -6.3857 29.2326 +115 1 5.73944 8.2048 2.38025 -0.334985 15.3443 16.2286 +116 1 4.92058 0.739392 2.48512 1.8123 5.57771 -0.399822 +117 1 6.61747 8.14877 1.63757 -7.92973 14.3058 -0.0863647 +118 1 7.37923 0.805843 1.70616 17.0436 -4.06349 -13.2175 +119 1 7.38533 8.17909 2.55221 2.10247 4.05286 -21.3656 +120 1 6.66981 0.91359 2.42776 -18.0385 -1.7859 9.16667 +121 1 8.21433 1.71804 1.64878 9.58557 -8.70073 -6.06848 +122 1 0.91795 2.50647 1.62107 -49.2165 -42.2319 12.3144 +123 1 0.778719 1.62612 2.3667 15.8366 8.16624 0.723179 +124 1 0.0388825 2.56454 2.43408 -0.65123 -11.9302 4.78295 +125 1 1.70614 1.64161 1.56714 -4.83448 1.54656 8.88708 +126 1 2.55772 2.51525 1.68348 -33.0305 -26.0768 -4.05159 +127 1 2.46774 1.68666 2.4295 -0.728639 -2.90689 1.14987 +128 1 1.58495 2.48207 2.53043 32.1395 -14.2129 -42.8967 +129 1 3.28639 1.69638 1.58862 0.141668 -5.07807 4.69228 +130 1 4.07581 2.46356 1.66204 5.75617 5.24573 6.028 +131 1 4.09064 1.65395 2.45941 5.06207 -1.15698 -3.64398 +132 1 3.2978 2.42597 2.51229 -0.392826 8.06961 -8.70923 +133 1 4.99952 1.60143 1.58928 -25.5713 -7.8385 22.8567 +134 1 5.66634 2.3835 1.71386 21.3679 17.6667 -19.1597 +135 1 5.74656 1.70527 2.50917 3.11288 -14.4009 7.07914 +136 1 4.97163 2.46224 2.45828 -14.3686 2.77193 11.4917 +137 1 6.62989 1.62285 1.56611 -20.0211 14.8617 27.1541 +138 1 7.37036 2.42163 1.58976 1.23932 26.194 15.084 +139 1 7.49234 1.71782 2.38524 -11.5645 -3.14792 16.0927 +140 1 6.57493 2.44646 2.50738 3.76278 -0.484364 -1.65815 +141 1 8.13855 3.28395 1.66364 9.95915 -4.6352 -13.1677 +142 1 0.822632 4.13968 1.61013 -1.66869 -18.1546 6.90643 +143 1 0.836195 3.27368 2.50106 -4.0013 3.27813 -2.23185 +144 1 0.00706469 4.04664 2.42415 6.78153 4.66429 11.0832 +145 1 1.56864 3.19926 1.57501 43.2252 54.2341 22.2486 +146 1 2.37435 4.19613 1.65007 19.5365 -23.6872 -5.11708 +147 1 2.53204 3.33272 2.45976 -10.1616 -1.37273 8.96239 +148 1 1.5958 4.02298 2.45513 4.44558 4.83545 -0.957126 +149 1 3.24862 3.20562 1.71329 33.7169 30.1535 -8.86948 +150 1 4.04966 4.11271 1.69147 14.455 0.133261 -16.0308 +151 1 4.17313 3.29199 2.42566 -5.80506 -5.3643 5.35172 +152 1 3.37886 4.04594 2.4591 -12.864 4.86539 14.8631 +153 1 5.00029 3.3715 1.7428 -16.124 -51.6521 -51.6846 +154 1 5.71525 4.10565 1.71106 18.126 11.5713 -25.6554 +155 1 5.67368 3.37853 2.52254 40.5036 -38.7002 16.4445 +156 1 4.98188 4.047 2.42098 -44.4942 70.6847 47.3189 +157 1 6.52567 3.216 1.71371 -0.385424 4.96723 -0.762826 +158 1 7.40007 4.08176 1.73877 -6.32286 -1.56827 -20.7524 +159 1 7.42837 3.30042 2.4503 -10.1629 -6.83382 9.16894 +160 1 6.52178 4.09551 2.40152 8.21405 -5.0269 3.15343 +161 1 0.00699263 4.85762 1.69229 -17.0824 5.05692 -6.94595 +162 1 0.756152 5.6631 1.60232 14.3979 15.6472 -4.59775 +163 1 0.764682 4.99903 2.39299 18.2885 -21.5851 21.4239 +164 1 0.0800264 5.75765 2.41619 -22.1201 11.2764 3.26076 +165 1 1.60226 4.84293 1.69094 -9.96687 23.2298 -5.36928 +166 1 2.38001 5.77059 1.56073 -4.13582 -26.0328 27.2432 +167 1 2.39304 4.87599 2.45449 3.86796 9.40324 7.0282 +168 1 1.5595 5.8443 2.45554 15.3251 -19.3503 -10.1983 +169 1 3.24805 4.8639 1.55208 5.72697 0.833939 9.91621 +170 1 4.12523 5.83768 1.72183 2.66681 -7.18069 -9.93584 +171 1 4.14719 4.98927 2.48442 -5.36599 -4.29088 6.08995 +172 1 3.29103 5.75037 2.41213 -9.14312 -21.8308 11.1485 +173 1 4.88531 4.96658 1.71552 5.62499 -3.03462 -8.19539 +174 1 5.80164 5.66001 1.66617 -22.0309 23.7646 0.752493 +175 1 5.79599 4.88622 2.4436 -18.3543 9.31939 -6.6266 +176 1 4.94007 5.78406 2.4889 7.47518 -6.1933 -6.95152 +177 1 6.50282 4.96059 1.57437 23.9581 -12.4339 8.07292 +178 1 7.43162 5.77666 1.60532 -16.9632 -9.02864 21.2089 +179 1 7.30902 4.88901 2.38072 1.39073 12.4251 10.603 +180 1 6.52191 5.81931 2.5443 7.19321 -57.902 -45.2674 +181 1 0.0825324 6.49799 1.58172 -0.0568703 17.3702 26.5223 +182 1 0.807327 7.40344 1.54436 38.413 9.53604 44.8678 +183 1 0.85313 6.5885 2.46372 -17.206 13.7674 -10.0743 +184 1 0.0766958 7.42441 2.49843 -14.0409 -5.69227 -10.6889 +185 1 1.56626 6.64679 1.65111 17.2201 -21.881 29.7832 +186 1 2.51758 7.48828 1.7101 -1.12703 -9.37355 7.34939 +187 1 2.48642 6.48139 2.37761 -17.45 9.10758 18.4987 +188 1 1.62607 7.39059 2.4668 5.47881 2.11068 -4.08662 +189 1 3.22096 6.48273 1.68127 15.0894 18.1205 -19.6751 +190 1 4.01435 7.47003 1.70259 9.92584 -36.0532 -31.9009 +191 1 4.01053 6.48307 2.56537 4.58494 43.5966 -38.8488 +192 1 3.31708 7.46346 2.49246 -11.1632 -6.704 4.9273 +193 1 4.97912 6.56412 1.70872 -0.0323444 1.40088 -5.51009 +194 1 5.76314 7.42951 1.73429 -4.71194 -18.4847 -18.3917 +195 1 5.75053 6.57569 2.52583 -15.5416 2.95473 -19.9489 +196 1 4.86788 7.33538 2.51839 21.348 1.25465 -21.9702 +197 1 6.54919 6.48383 1.72129 1.36669 8.74928 -8.3147 +198 1 7.40692 7.48075 1.59274 -4.17636 -24.5364 8.08039 +199 1 7.31105 6.49008 2.55841 18.9084 8.98379 -5.81349 +200 1 6.56124 7.4093 2.46898 3.88266 -3.866 3.64736 +201 1 0.0467578 0.0587236 3.25639 -2.58837 -3.06001 8.14477 +202 1 0.919472 0.840587 3.2901 -13.7955 -3.94396 11.0802 +203 1 0.913851 8.17129 4.10222 -17.0314 2.36091 -15.061 +204 1 8.12452 0.831674 4.11824 2.96137 1.66258 0.705395 +205 1 1.72266 8.12268 3.2983 -16.5809 -0.000561518 15.0322 +206 1 2.36681 0.848699 3.23189 33.3023 -3.20785 26.2082 +207 1 2.52451 0.093755 4.0501 -20.4816 -4.23237 16.7496 +208 1 1.57332 0.89934 4.17862 1.65408 -10.4059 -4.79402 +209 1 3.23411 8.18086 3.33998 20.9401 7.85353 -15.8307 +210 1 4.12777 0.912462 3.28751 -3.54395 -8.15241 -0.704223 +211 1 4.05479 8.16789 4.17086 6.43266 7.42359 -18.6916 +212 1 3.3412 0.763098 4.14988 -8.17365 16.5822 -19.2151 +213 1 4.85923 8.19378 3.30398 3.75427 6.29815 -1.39384 +214 1 5.723 0.836221 3.31262 4.07436 -7.7371 -12.3645 +215 1 5.78765 0.0695661 4.10746 2.41957 -4.40965 -1.14115 +216 1 4.97909 0.892899 4.12401 -13.5931 -16.8127 1.66952 +217 1 6.57108 0.0657357 3.30807 -10.4223 -10.045 -0.47006 +218 1 7.35373 0.738008 3.24493 15.9915 16.7978 9.43624 +219 1 7.34677 0.0332152 4.15763 12.3358 5.5849 -5.20193 +220 1 6.67147 0.918341 4.12524 -9.23951 -11.4667 0.577623 +221 1 0.0788919 1.58016 3.21314 -1.55258 49.5779 50.5391 +222 1 0.904188 2.40885 3.22233 -31.0956 -2.82504 30.7646 +223 1 0.877149 1.74225 4.15165 7.55452 -10.7555 -4.03202 +224 1 0.0936835 2.40444 4.16194 -19.0736 7.56858 -3.47745 +225 1 1.71236 1.61805 3.29179 -19.7602 28.7111 2.45155 +226 1 2.5486 2.41776 3.31547 -43.6679 25.9149 -16.2942 +227 1 2.39734 1.55251 4.06577 15.8032 7.53109 12.4652 +228 1 1.72237 2.5181 4.15876 -10.7679 -10.2774 -3.05137 +229 1 3.23039 1.71099 3.29502 25.8646 -44.0791 -9.55739 +230 1 4.12827 2.45813 3.1934 -6.48806 -10.3202 8.62038 +231 1 4.19407 1.63495 4.09603 -15.4993 6.39445 10.1662 +232 1 3.20761 2.36838 4.07177 19.5744 11.0493 29.9438 +233 1 4.94979 1.63514 3.37535 1.21152 5.67416 -27.5114 +234 1 5.82776 2.47766 3.34313 -3.66364 1.42568 -1.20833 +235 1 5.76542 1.58538 4.03513 14.4098 19.4192 12.2978 +236 1 4.95489 2.43394 4.07273 -1.13246 5.06376 7.36624 +237 1 6.661 1.60077 3.30919 -3.43354 8.94885 -5.94598 +238 1 7.49515 2.56092 3.28033 -10.5336 -12.2625 1.51454 +239 1 7.39275 1.71767 4.16117 3.5537 3.96098 0.811537 +240 1 6.54244 2.56469 4.20941 11.0399 -32.6669 -26.4629 +241 1 8.2116 3.30444 3.37137 5.74747 4.63382 -14.2394 +242 1 0.840624 4.14226 3.27407 -5.48884 -5.61804 0.498093 +243 1 0.734437 3.23139 4.08576 22.8281 5.93798 4.2063 +244 1 0.0471721 4.13123 4.11158 -4.3827 3.27424 0.087671 +245 1 1.70286 3.20807 3.23042 -2.96775 14.0769 10.9943 +246 1 2.38769 4.13105 3.27446 4.88078 -2.82576 -1.60425 +247 1 2.4087 3.28686 4.02353 16.6104 0.201322 7.1777 +248 1 1.69983 4.0678 4.13415 -10.6977 3.91895 2.19645 +249 1 3.34377 3.23634 3.36851 -11.3528 1.51526 -17.2895 +250 1 4.2055 4.03294 3.37597 -23.3492 5.34016 -26.85 +251 1 4.03955 3.26203 4.11941 11.7033 -4.94552 16.1773 +252 1 3.21963 4.01243 4.16102 5.66091 6.82551 -5.40832 +253 1 4.83261 3.19517 3.32313 20.1816 8.52525 -2.26656 +254 1 5.77148 4.16495 3.28824 -31.489 -26.7787 -6.90732 +255 1 5.82425 3.30115 4.19401 -37.1473 -6.40083 -11.3511 +256 1 4.87724 4.09609 4.11549 36.2568 -10.3151 3.06059 +257 1 6.58329 3.33973 3.22197 0.0461967 -7.66729 -2.40242 +258 1 7.43644 4.05966 3.30265 -3.56999 5.92726 -1.37248 +259 1 7.48286 3.29775 4.19646 -3.89008 -9.4431 -11.0777 +260 1 6.47907 4.03353 4.01383 29.8324 22.3851 15.73 +261 1 8.15241 5.02846 3.31122 10.6595 -5.28085 -5.36552 +262 1 0.804631 5.8376 3.20576 13.4276 -32.1322 14.0647 +263 1 0.877129 4.8969 4.13251 -1.47043 5.42126 -0.0257482 +264 1 0.0651636 5.75976 4.1954 -9.31697 -6.72952 -15.907 +265 1 1.57617 4.92532 3.28718 5.51341 5.68743 -3.59864 +266 1 2.42583 5.72219 3.30114 4.35376 1.25963 -4.44713 +267 1 2.4551 4.89394 4.08913 0.180251 2.9051 2.6698 +268 1 1.67099 5.80732 4.08057 -5.18981 -1.73911 5.86888 +269 1 3.33413 4.84944 3.32334 -2.55875 1.02427 -1.99572 +270 1 4.20493 5.83452 3.24979 -21.4386 -63.3893 34.6056 +271 1 4.19181 4.8901 4.01924 -15.0952 14.1984 13.5631 +272 1 3.36551 5.83759 4.08786 -9.40985 -16.2604 3.57159 +273 1 4.9921 4.89151 3.36329 -7.1819 8.21085 -25.7306 +274 1 5.77026 5.74279 3.2372 -19.2661 -13.3988 15.8911 +275 1 5.68576 4.90444 4.10854 12.1482 9.27276 4.35592 +276 1 4.84395 5.80423 4.20869 23.9245 -11.025 -23.296 +277 1 6.4858 4.83859 3.18898 36.5327 24.7135 15.3623 +278 1 7.30315 5.68446 3.36881 -0.385614 18.5722 -20.0571 +279 1 7.37309 4.9455 4.05168 -2.3203 -17.2743 20.9328 +280 1 6.63896 5.83294 4.18727 -7.1922 -10.1498 -0.517575 +281 1 0.0942908 6.52233 3.3159 -35.7657 14.4096 -15.937 +282 1 0.836387 7.40457 3.20726 4.47284 -0.4112 17.4557 +283 1 0.739312 6.64758 4.08638 39.4722 -18.3951 12.5032 +284 1 8.21631 7.30153 4.06221 -15.2581 27.9702 -0.672668 +285 1 1.58758 6.54973 3.25882 10.9016 11.7867 8.01769 +286 1 2.56536 7.3619 3.34369 -76.1678 6.55793 -73.9603 +287 1 2.52556 6.61112 4.10224 -30.5256 -34.6487 7.0656 +288 1 1.62124 7.32393 4.18622 0.536802 -1.56833 -6.92191 +289 1 3.3681 6.64037 3.37818 -8.53205 -51.1792 -62.7851 +290 1 4.15298 7.36163 3.20593 -21.9528 4.612 22.3686 +291 1 4.12464 6.54108 4.035 14.4356 20.1369 22.2034 +292 1 3.19906 7.31073 4.01315 82.3215 73.9575 117.35 +293 1 4.9065 6.52075 3.26638 28.3768 26.425 6.32862 +294 1 5.74138 7.36096 3.25092 -0.970474 8.69807 4.03129 +295 1 5.81652 6.58456 4.03756 -14.737 -0.580193 0.741413 +296 1 4.87586 7.39212 4.03191 6.20313 -4.00572 5.92319 +297 1 6.48611 6.49412 3.21889 20.5434 47.1119 52.8917 +298 1 7.41876 7.4098 3.23912 -0.409624 -8.77258 11.2401 +299 1 7.35972 6.63444 4.07034 1.58562 -5.33459 -2.2315 +300 1 6.64271 7.48657 4.18074 -12.6903 -3.8877 -6.90745 +301 1 8.18545 0.00495327 4.98201 0.835961 10.4978 -8.83054 +302 1 0.830861 0.760813 4.98094 -9.95647 8.66756 -7.1447 +303 1 0.808969 0.00641337 5.74397 -4.48252 1.30502 4.67537 +304 1 0.018812 0.795135 5.84676 0.988121 0.902183 -11.1018 +305 1 1.60862 0.0119183 4.84308 17.0508 -2.91068 17.4808 +306 1 2.50239 0.876955 4.96833 -9.09304 -5.08176 -4.69214 +307 1 2.44832 8.14323 5.81234 6.77585 9.13889 -19.0494 +308 1 1.56911 0.731109 5.75394 17.4698 11.7404 -4.99849 +309 1 3.28793 0.0458368 4.91142 -7.08209 -9.95818 14.0315 +310 1 4.07208 0.823519 4.87126 26.6153 -9.6486 13.2451 +311 1 4.06672 0.0477209 5.80002 10.3282 0.566915 -15.466 +312 1 3.2042 0.88056 5.78404 3.8932 -8.75566 -1.61055 +313 1 5.02696 0.0222739 4.88991 -12.0715 4.27124 3.2294 +314 1 5.73734 0.886325 4.85298 9.71713 -6.59089 13.6933 +315 1 5.79543 0.0389128 5.76135 -3.4407 3.92019 -0.496418 +316 1 4.85161 0.780997 5.82861 2.47749 38.2945 -34.2513 +317 1 6.64858 0.0906911 4.97808 -13.982 -18.784 -13.0607 +318 1 7.30429 0.900733 5.00382 63.7384 -13.5798 -32.445 +319 1 7.4114 8.15633 5.76261 6.64498 1.40027 -2.33346 +320 1 6.66824 0.783026 5.72649 -29.5414 5.85716 47.7215 +321 1 0.0281683 1.66949 4.95949 -0.425666 -3.96058 2.91208 +322 1 0.893447 2.47998 4.9969 -1.93266 1.10148 -5.4469 +323 1 0.843715 1.6221 5.7589 -0.766033 4.56211 -3.21682 +324 1 0.0782454 2.53663 5.73256 -1.35265 -11.3593 -4.90859 +325 1 1.65079 1.66704 4.93767 -0.533365 0.139965 4.11876 +326 1 2.51601 2.38441 4.90805 0.649871 6.98133 -0.140965 +327 1 2.41175 1.72195 5.72474 2.84663 -8.86686 7.73621 +328 1 1.61538 2.54316 5.81674 -0.089029 -19.7728 -12.4678 +329 1 3.35891 1.54703 4.95536 -9.48818 22.4331 -2.56554 +330 1 4.08195 2.54313 5.01426 16.1748 -2.70068 -21.0768 +331 1 4.12034 1.74262 5.81366 10.5637 -13.2904 -3.74489 +332 1 3.37175 2.4672 5.72729 -31.5422 -3.32565 13.6818 +333 1 5.0033 1.68848 4.95948 -13.0392 -13.8401 -3.80319 +334 1 5.66589 2.47997 4.89515 25.4212 2.24436 -8.70857 +335 1 5.79028 1.55903 5.82666 2.05757 18.2253 -24.3713 +336 1 5.0311 2.46113 5.68951 -16.9377 1.04 21.5338 +337 1 6.57827 1.56896 5.01204 -21.5711 32.5342 -4.2816 +338 1 7.31623 2.52382 4.98258 18.6955 -8.52314 -2.25127 +339 1 7.45461 1.64332 5.76278 -16.0261 1.47893 -16.982 +340 1 6.64089 2.42957 5.78128 -11.0128 0.688597 0.00936653 +341 1 0.0932375 3.33117 4.94446 -5.57952 -6.38154 1.87127 +342 1 0.757472 4.19176 4.95128 10.4651 -6.09524 -1.36969 +343 1 0.907905 3.31127 5.7437 -27.4593 -10.6172 -1.55436 +344 1 0.042027 4.05791 5.75958 -12.212 5.31553 -4.25834 +345 1 1.73758 3.25237 5.02547 -7.72352 0.251809 -15.9993 +346 1 2.4871 4.0191 4.9543 -17.108 24.4302 2.09179 +347 1 2.45668 3.23081 5.78465 2.15315 9.79763 4.28788 +348 1 1.58106 4.05092 5.80356 25.1427 18.6418 -4.49313 +349 1 3.19249 3.31456 5.03239 24.0259 -22.2006 -10.8088 +350 1 4.20707 4.15779 4.866 -22.1265 -5.11578 15.6203 +351 1 4.10653 3.22389 5.85277 -11.4198 11.552 -29.8203 +352 1 3.32529 4.01575 5.8236 -9.29377 10.539 -6.33768 +353 1 5.02426 3.35158 5.01899 -31.0395 -2.45923 -24.1365 +354 1 5.68644 4.17189 4.85403 7.36649 -6.63658 10.5871 +355 1 5.74132 3.29275 5.69662 23.2126 4.63385 22.4488 +356 1 4.92531 4.19073 5.71088 -1.56015 -9.54037 12.8094 +357 1 6.54444 3.23385 4.93781 3.72392 28.1796 29.5331 +358 1 7.41233 4.02229 4.92924 -1.20364 12.0626 9.54412 +359 1 7.4663 3.28529 5.82942 -29.7597 -4.87929 -37.7444 +360 1 6.60644 4.05138 5.75927 -5.95188 5.2753 -7.63938 +361 1 8.20344 4.97671 5.0085 -9.77785 -27.0171 -16.098 +362 1 0.764125 5.65629 4.97235 19.2848 26.171 -13.514 +363 1 0.873777 4.9677 5.68286 -0.798932 -14.5746 27.2238 +364 1 8.1297 5.72693 5.67887 36.2224 14.0656 51.1647 +365 1 1.7318 5.02959 5.01529 -5.49043 -14.6131 -16.8314 +366 1 2.44542 5.85219 4.93063 19.3822 -11.3762 -19.1618 +367 1 2.55143 4.96012 5.6972 2.49476 -2.70049 4.14057 +368 1 1.7425 5.82205 5.68004 -17.6493 -28.263 45.9708 +369 1 3.3219 4.92271 4.83646 -0.36054 0.182371 1.57441 +370 1 4.15401 5.67616 4.9285 -21.3575 6.09757 11.4691 +371 1 4.07715 4.94174 5.74451 -0.595544 -7.12056 -1.40506 +372 1 3.31639 5.79418 5.70206 -6.4923 -7.4901 3.07645 +373 1 4.92581 4.94202 4.97984 -0.22012 5.90431 -14.5879 +374 1 5.73821 5.69855 4.88283 0.98112 8.81137 -0.251897 +375 1 5.70683 4.9474 5.70386 9.48927 0.653977 8.8924 +376 1 4.96412 5.79635 5.67508 -8.29845 -17.1654 19.2091 +377 1 6.48765 4.91573 4.91811 9.87445 -1.02048 -0.929801 +378 1 7.42803 5.76565 5.01887 -36.8924 9.29378 -39.8178 +379 1 7.31535 5.01349 5.75729 -2.96639 -15.6116 3.19898 +380 1 6.51112 5.80276 5.76292 -0.511839 0.0343249 -1.86567 +381 1 0.0752499 6.50198 4.93503 -9.95853 14.5519 3.18185 +382 1 0.749032 7.44313 4.93057 9.36322 -4.26106 -6.17112 +383 1 0.799308 6.59761 5.72007 7.23025 -2.947 1.48543 +384 1 0.0646916 7.47006 5.72188 -15.7332 -12.5303 9.25543 +385 1 1.64476 6.54961 5.03014 -20.9538 30.4927 -38.3434 +386 1 2.45435 7.39325 4.88002 3.42796 3.8663 5.03137 +387 1 2.4342 6.59097 5.67369 23.2905 17.249 22.0616 +388 1 1.54778 7.4679 5.8363 19.3115 -12.9738 -21.1698 +389 1 3.32159 6.57391 4.94635 0.920374 5.37222 -4.76541 +390 1 4.12734 7.43087 4.87631 0.0949958 -12.9619 14.1535 +391 1 4.03648 6.57336 5.82487 9.67898 -2.57585 -4.33725 +392 1 3.37401 7.44443 5.83215 -8.90767 -10.0262 -16.7558 +393 1 4.95785 6.5313 4.96795 -5.28369 20.3288 -12.6073 +394 1 5.72446 7.44815 4.95617 -0.295615 -4.81227 -6.28599 +395 1 5.67507 6.56368 5.75557 19.5363 2.36566 3.12879 +396 1 4.99604 7.36578 5.82253 -12.0795 7.56208 -16.0156 +397 1 6.47952 6.65183 4.84549 7.81673 -1.192 17.7565 +398 1 7.49045 7.38842 4.86267 -3.31154 -1.72952 10.3926 +399 1 7.31515 6.64393 5.7627 1.65473 -7.46902 -9.80451 +400 1 6.51213 7.44705 5.67942 6.88055 -5.46286 6.12471 +401 1 0.0806264 0.0886591 6.67061 2.86389 -53.8636 -44.0246 +402 1 0.883633 0.899989 6.55658 -11.6958 -11.9156 5.39561 +403 1 0.88757 0.0447352 7.4623 -6.5852 -8.63148 -1.54458 +404 1 0.00589996 0.782701 7.30583 -3.57511 51.2033 48.3924 +405 1 1.70878 0.0185969 6.53425 -9.91562 -0.171369 19.1044 +406 1 2.47179 0.820184 6.65916 -10.0875 0.778119 -25.3377 +407 1 2.53937 0.0160974 7.34796 -3.95783 -6.52463 5.98309 +408 1 1.62994 0.765044 7.35659 9.0133 10.535 7.11032 +409 1 3.30704 0.041501 6.48376 -12.5346 2.59741 23.4233 +410 1 4.02443 0.849646 6.63591 28.9911 -27.1685 -8.99322 +411 1 4.05271 0.0416361 7.37632 0.533135 -1.75778 -2.17869 +412 1 3.19386 0.898466 7.37702 15.4736 -11.3366 18.5812 +413 1 4.93306 0.0872445 6.49555 4.8751 -33.7979 36.6921 +414 1 5.84884 0.883258 6.55834 -5.60524 -28.829 17.1111 +415 1 5.81564 0.024621 7.40384 -2.36039 -5.56484 -6.47242 +416 1 4.961 0.816895 7.40894 -1.64345 1.03662 -2.05135 +417 1 6.67176 0.000709987 6.50931 -8.49107 -0.789231 11.0199 +418 1 7.42872 0.868407 6.55728 -5.95092 -10.3429 1.39671 +419 1 7.36138 8.18623 7.46478 9.04825 4.48366 -10.7424 +420 1 6.59985 0.825831 7.39669 4.88737 -2.34866 2.27965 +421 1 8.14416 1.67759 6.49013 32.825 -1.32457 17.7447 +422 1 0.9037 2.40379 6.60352 -22.6991 13.3728 -5.6252 +423 1 0.83815 1.6821 7.34463 -6.45777 -9.82884 14.5288 +424 1 8.19206 2.55987 7.48041 1.09967 -24.6646 -31.5822 +425 1 1.61029 1.6565 6.61062 19.3859 -4.50632 -8.40911 +426 1 2.39042 2.47779 6.49991 10.3869 -7.14038 20.8685 +427 1 2.43336 1.66264 7.31159 -0.298923 7.67874 9.60508 +428 1 1.68521 2.53757 7.43341 0.0908995 -20.3899 -19.4953 +429 1 3.34574 1.55658 6.57542 -29.1499 40.141 -5.99747 +430 1 4.09567 2.50385 6.58715 2.92988 -17.1157 8.90269 +431 1 4.06967 1.60141 7.36073 8.28003 9.68724 13.2999 +432 1 3.26291 2.44686 7.41755 -1.72761 -1.27824 0.484775 +433 1 5.02343 1.63061 6.57358 -10.9076 3.24904 2.06921 +434 1 5.8117 2.52535 6.48584 -2.10788 -3.23133 8.48842 +435 1 5.76381 1.64883 7.37339 7.06147 -0.584215 3.21917 +436 1 4.99697 2.44099 7.45915 -1.75923 11.2498 -19.4182 +437 1 6.62044 1.59458 6.63611 -5.65576 11.9066 -13.6974 +438 1 7.40085 2.40641 6.52565 -4.26631 17.0681 5.6259 +439 1 7.4086 1.68173 7.30269 7.67403 -2.22025 20.1658 +440 1 6.56414 2.4958 7.48155 2.02857 -0.65966 -9.40352 +441 1 8.16172 3.22 6.50779 31.0613 6.17733 37.0029 +442 1 0.778923 4.13348 6.47989 7.10682 -1.13444 17.3069 +443 1 0.731543 3.38344 7.32104 8.57141 -10.8353 -0.596329 +444 1 8.20703 4.11651 7.39737 -10.5501 6.3503 -2.89453 +445 1 1.5556 3.22612 6.62242 10.8567 18.3759 1.80723 +446 1 2.43596 4.07218 6.65191 19.5996 1.93234 -23.7547 +447 1 2.42128 3.38357 7.48855 6.46322 -13.7769 -4.42002 +448 1 1.70183 4.1306 7.3251 -28.6202 8.98318 18.3174 +449 1 3.23368 3.21004 6.55845 -1.66335 0.810928 5.98502 +450 1 4.02817 4.01745 6.59179 9.73332 14.3603 -1.234 +451 1 4.04024 3.24371 7.33596 9.19519 -2.61436 13.2612 +452 1 3.33578 4.03204 7.3761 -11.8519 11.1256 7.31388 +453 1 4.84615 3.34919 6.50516 30.474 -3.21025 16.5113 +454 1 5.79338 4.10407 6.63223 -1.4488 4.34379 -6.9657 +455 1 5.71769 3.33306 7.36343 3.56485 -8.31237 5.17357 +456 1 4.89884 4.06687 7.36632 1.94898 -1.38193 2.81677 +457 1 6.61297 3.34048 6.58436 -38.9416 -40.8203 -5.50523 +458 1 7.30794 4.01061 6.56591 40.2005 61.5018 -17.6954 +459 1 7.37741 3.36957 7.31145 38.0889 -52.6112 27.9446 +460 1 6.66665 4.01974 7.42717 -35.3166 42.1921 1.19147 +461 1 0.0452175 4.90338 6.62118 -6.71352 5.92623 -3.01906 +462 1 0.869367 5.66645 6.62279 -29.6122 19.3042 -24.6336 +463 1 0.858776 5.03104 7.45654 -16.814 -24.2615 8.51744 +464 1 8.14658 5.74936 7.4724 2.5583 -5.40279 -7.71149 +465 1 1.59957 4.95319 6.53572 14.873 -15.6204 -6.12191 +466 1 2.54529 5.66468 6.59785 -23.4011 43.3591 -27.461 +467 1 2.4961 5.03005 7.34302 -11.668 -32.1864 28.6337 +468 1 1.60544 5.69113 7.30132 37.8442 13.2739 23.8753 +469 1 3.24356 4.96073 6.59142 26.8133 -25.0989 -5.08933 +470 1 4.09781 5.67439 6.52285 2.63557 7.15813 7.05447 +471 1 4.18105 4.86276 7.35501 -9.07005 4.72655 -1.53462 +472 1 3.36767 5.65499 7.49749 6.09099 26.0319 -27.9028 +473 1 5.01795 4.94278 6.59504 -2.00637 0.995546 -1.6799 +474 1 5.7841 5.85399 6.63871 4.06216 -12.0086 -14.5693 +475 1 5.83404 5.02565 7.38856 -29.8707 -40.8918 -9.03319 +476 1 4.9605 5.83878 7.31445 -12.603 -27.5006 25.6094 +477 1 6.59477 4.88222 6.67554 -4.07568 1.88148 -17.9737 +478 1 7.35313 5.77701 6.52551 0.181186 3.4052 7.13046 +479 1 7.348 4.89641 7.37973 13.5892 1.99375 8.82978 +480 1 6.49663 5.74982 7.4422 46.6685 29.9241 -18.7201 +481 1 0.0491078 6.53098 6.47716 -5.83531 -0.141054 6.60445 +482 1 0.791488 7.40292 6.50563 -8.70546 -0.874788 22.49 +483 1 0.919931 6.51323 7.45776 -11.5314 25.4002 -28.1718 +484 1 0.0481113 7.40468 7.43229 -11.5944 -5.37754 -18.7674 +485 1 1.63473 6.52345 6.62888 -0.301482 5.86022 -13.1885 +486 1 2.54325 7.3746 6.52095 -7.01617 -1.6126 8.94816 +487 1 2.42821 6.65367 7.34715 -0.0947462 -6.49261 12.3075 +488 1 1.66344 7.43005 7.38619 -4.64698 1.83667 -2.7903 +489 1 3.21223 6.51896 6.65614 12.5802 -0.344258 -7.45446 +490 1 4.18524 7.3836 6.50889 -0.948752 5.15796 16.6381 +491 1 4.03479 6.58867 7.43482 10.4531 -7.07785 -21.0648 +492 1 3.31132 7.44815 7.43351 -1.0832 -4.66317 -4.42978 +493 1 5.00814 6.58691 6.66459 -15.2308 20.9466 -24.4589 +494 1 5.70889 7.39626 6.56563 14.4769 6.85637 10.1092 +495 1 5.73775 6.567 7.43094 6.72915 9.63092 8.95959 +496 1 4.91068 7.49261 7.37168 0.330155 -8.28614 -9.94049 +497 1 6.53726 6.65021 6.66417 -1.59265 -6.08794 -3.67401 +498 1 7.37246 7.29875 6.57444 7.56141 13.3939 8.59342 +499 1 7.35261 6.58373 7.49207 23.0737 -16.5957 -35.2353 +500 1 6.60589 7.39349 7.49219 -10.7096 3.92482 -19.5185 diff --git a/examples/mdi/dump.17Jun22.series.driver.tcp.4 b/examples/mdi/dump.17Jun22.series.driver.tcp.4 new file mode 100644 index 0000000000..847432833a --- /dev/null +++ b/examples/mdi/dump.17Jun22.series.driver.tcp.4 @@ -0,0 +1,1527 @@ +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +500 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 8.9390353509656766e+00 +0.0000000000000000e+00 8.9390353509656766e+00 +0.0000000000000000e+00 8.9390353509656766e+00 +ITEM: ATOMS id type x y z f_1[1] f_1[2] f_1[3] +1 1 0.0109462 8.91109 8.87705 -0.258023 0.625273 0.429284 +2 1 0.983178 0.93542 8.91066 -2.88593 0.281032 -1.95154 +3 1 0.886776 0.00353842 0.964105 -0.27179 0.383251 0.443719 +4 1 0.0722273 0.817966 0.815708 -0.663834 1.25489 -0.35451 +5 1 1.82919 8.8603 8.91164 0.346262 0.966337 0.327185 +6 1 2.71374 0.850558 0.0977971 -1.53533 0.952301 -0.539148 +7 1 2.75443 8.9152 0.943835 0.200679 -0.0265554 -0.862232 +8 1 1.72161 0.971413 0.796705 7.79754 -6.0811 1.58835 +9 1 3.47837 0.0294075 0.0515782 2.76325 -2.21894 -0.80311 +10 1 4.43186 0.961325 8.89919 -0.387918 -0.444884 0.950878 +11 1 4.37764 0.00631327 0.801109 0.844344 -0.87322 -0.116598 +12 1 3.59567 0.80748 0.974874 -0.705778 1.85625 -1.80855 +13 1 5.35026 8.89566 0.0208816 -0.442875 -0.272596 -0.473028 +14 1 6.3022 0.978028 0.0782288 -3.05518 -2.94099 -0.889505 +15 1 6.27707 0.0297536 0.962734 -0.0515917 0.772188 -1.05602 +16 1 5.30223 0.918655 0.899444 1.33545 0.759601 -1.29769 +17 1 7.0769 0.0948096 0.0649153 0.098645 -1.06535 0.292165 +18 1 8.09537 0.913626 0.0774105 -0.154847 0.414543 -0.451754 +19 1 8.08165 0.0818588 0.895196 -0.689773 -1.28143 0.929968 +20 1 7.14638 0.885276 0.891299 0.487793 0.733541 0.918445 +21 1 8.89456 1.84483 0.0434425 0.886905 -0.621358 -0.495646 +22 1 0.935681 2.64324 0.0406455 -1.34335 0.213362 -1.25695 +23 1 0.966071 1.69976 0.948945 -7.88058 11.3257 -7.25569 +24 1 0.0121607 2.66637 0.881115 -0.232812 0.533689 1.18415 +25 1 1.85044 1.81859 0.00192994 -1.7495 0.19048 0.1992 +26 1 2.68148 2.7251 0.0685109 -1.25528 -0.916148 -1.01459 +27 1 2.62716 1.70715 0.839166 0.688023 2.33788 1.05919 +28 1 1.6905 2.59418 0.903739 1.58905 0.257971 0.508129 +29 1 3.57454 1.77719 8.88663 0.186742 -0.0628404 0.80372 +30 1 4.38099 2.63699 8.92556 0.253897 0.0578989 -0.178058 +31 1 4.45919 1.78484 0.892793 0.372262 0.580252 -1.28381 +32 1 3.55804 2.657 0.821946 0.208194 0.440929 1.42052 +33 1 5.39579 1.85576 0.0513097 -2.11231 -0.770148 -0.833202 +34 1 6.28486 2.68552 0.0861957 -0.390024 -0.099671 -1.25573 +35 1 6.16167 1.79587 0.852166 3.13123 -0.282736 3.8241 +36 1 5.43841 2.67896 0.926914 -0.906522 -0.132525 -0.585389 +37 1 7.09214 1.72405 8.83985 3.26876 6.20695 4.03515 +38 1 7.96694 2.76043 0.0935037 2.29966 -0.680397 -1.28039 +39 1 8.06525 1.69772 0.940378 0.498274 0.445905 0.0355574 +40 1 7.16698 2.58338 0.88179 -1.8895 -0.0707859 1.12114 +41 1 0.0210451 3.48041 0.0428158 0.862491 -0.329006 -0.681709 +42 1 0.874431 4.40275 0.0131769 0.218928 -0.148848 0.324321 +43 1 0.851364 3.60752 0.914082 0.352487 -0.527665 -0.410754 +44 1 0.0749717 4.51844 0.974577 -0.257295 -0.287753 -0.288054 +45 1 1.76248 3.58626 0.0539576 0.480316 -2.29368 -1.63127 +46 1 2.72367 4.4241 0.0474256 0.0272964 0.241712 -0.452415 +47 1 2.73289 3.61199 0.901343 -0.0645249 -1.94992 -0.502421 +48 1 1.8456 4.38069 0.843492 -0.349918 1.31176 2.27682 +49 1 3.50387 3.55674 0.0315796 1.56114 -0.0224047 0.116984 +50 1 4.49692 4.37908 0.0780585 -4.54206 0.213106 -5.58215 +51 1 4.46671 3.57478 0.880458 -0.334204 -0.938728 0.874478 +52 1 3.58815 4.43 0.950374 0.652985 -1.92511 -1.59862 +53 1 5.3866 3.58372 8.92789 -1.19711 -2.22155 0.617325 +54 1 6.17276 4.37217 8.86047 6.00842 1.34471 4.78274 +55 1 6.27432 3.53871 0.907449 -0.148389 -0.137473 -0.523414 +56 1 5.27909 4.47835 0.809401 8.23917 -3.14067 4.34956 +57 1 7.09737 3.53698 8.87413 0.14026 -0.233191 0.941929 +58 1 7.96586 4.56922 8.84208 6.8748 -6.48505 1.75868 +59 1 8.1189 3.63425 0.96148 -3.00277 -1.46323 -4.15536 +60 1 7.14279 4.43222 0.962078 -0.0459577 0.247999 0.321752 +61 1 8.89637 5.43177 8.92691 0.327116 0.812268 0.0679643 +62 1 0.854018 6.30348 0.0813318 1.06274 -7.24911 -7.87042 +63 1 0.873415 5.41923 0.812761 -0.31071 -0.409433 0.423823 +64 1 8.88236 6.35419 0.863575 -0.753758 -3.06962 -0.690381 +65 1 1.76334 5.40934 8.88249 1.8326 1.29836 1.91996 +66 1 2.68777 6.21767 8.90577 0.0461489 1.51967 -0.262666 +67 1 2.66088 5.41906 0.821357 0.262109 -0.890774 -0.241847 +68 1 1.86017 6.31332 0.804602 -1.38053 -1.13952 0.850174 +69 1 3.64435 5.42051 8.90358 -2.6101 -2.17442 -0.370474 +70 1 4.37466 6.25131 8.85278 3.71832 2.70453 0.946098 +71 1 4.53047 5.2708 0.824393 -3.54051 3.8431 0.931364 +72 1 3.61222 6.27635 0.96909 -4.05414 0.604922 -3.58471 +73 1 5.40042 5.34751 8.8935 -0.719369 -0.36085 0.212296 +74 1 6.18215 6.3156 0.0196993 0.267387 0.110688 0.223648 +75 1 6.27516 5.37868 0.90209 -1.0642 -0.241069 0.481931 +76 1 5.31268 6.25584 0.875522 0.133781 0.115172 0.026661 +77 1 7.20113 5.30633 8.84474 -4.87308 6.78349 0.0391413 +78 1 7.95512 6.30497 0.092705 6.00614 -6.0265 -0.649957 +79 1 8.08767 5.35538 0.811364 -1.15126 0.392579 0.741715 +80 1 7.08607 6.1919 0.926051 0.630581 3.46407 -2.46157 +81 1 8.92405 7.0566 8.88782 -1.53371 0.564813 -0.0213323 +82 1 0.905011 8.13513 0.0600006 -0.504969 -0.194195 -0.00181653 +83 1 0.816253 7.07033 0.801556 1.36958 7.74762 7.34595 +84 1 8.83925 8.07727 0.907684 2.46931 1.67506 1.17354 +85 1 1.86043 7.09328 8.91972 -0.773441 0.857837 1.39948 +86 1 2.76541 7.99166 0.0440794 -0.77809 1.05822 0.425741 +87 1 2.67654 7.18636 0.91183 2.62219 -2.00002 -0.219028 +88 1 1.8788 7.9677 0.915621 -0.894934 2.07357 -1.21117 +89 1 3.59357 7.13026 0.0332195 -0.388167 0.00237965 -0.544686 +90 1 4.38663 8.07233 8.88382 0.174711 -0.440379 0.0897133 +91 1 4.5359 7.22854 0.936578 -2.37627 -1.04519 -2.35662 +92 1 3.63538 7.97981 0.824881 -1.61206 1.29888 2.0997 +93 1 5.3271 7.23059 8.92328 -0.111431 -0.20975 0.289951 +94 1 6.30867 8.05581 8.84577 0.0946421 0.0525728 2.57365 +95 1 6.32003 7.15576 0.891457 -0.2569 -0.483959 0.0547371 +96 1 5.40661 7.9868 0.968462 0.415884 0.0845497 -0.268424 +97 1 7.22798 7.08713 0.0563741 -5.45853 5.72078 -0.51002 +98 1 8.05735 8.06186 0.0753342 -0.611004 1.73052 -2.95918 +99 1 8.10922 7.21906 0.806609 -0.400473 -2.4357 2.42821 +100 1 7.16998 8.08498 0.846622 0.253892 0.388538 0.000271703 +101 1 8.88419 0.00785958 1.88382 0.148531 -0.55276 -3.06718 +102 1 0.806706 0.963107 1.6981 0.146821 -6.1479 7.24676 +103 1 0.81371 8.93107 2.59291 1.58623 0.25767 2.66866 +104 1 0.0914118 0.851308 2.7806 -2.96193 1.34432 -3.85013 +105 1 1.70908 0.055279 1.86232 -0.26684 0.0875329 -0.306957 +106 1 2.72497 0.940903 1.70203 -0.757536 -0.918748 1.71384 +107 1 2.71129 0.0639965 2.67102 -0.311468 0.261861 0.646041 +108 1 1.73889 0.96912 2.64369 0.123913 0.173982 0.666446 +109 1 3.52533 0.0194588 1.83263 1.01391 -0.00454228 -0.284845 +110 1 4.50633 0.992013 1.70842 -3.51938 -2.99082 2.23564 +111 1 4.49463 8.9275 2.60712 -6.23135 -0.421499 6.59704 +112 1 3.51061 0.932206 2.63613 0.265327 0.172351 0.555119 +113 1 5.26459 0.0845656 1.88118 6.41483 1.44516 -5.35427 +114 1 6.26822 0.943133 1.78953 -0.172034 -0.0988047 -0.238973 +115 1 6.20352 0.0931252 2.63772 -0.251863 0.451194 0.97073 +116 1 5.33497 0.961022 2.74861 1.85573 -2.10168 -0.655218 +117 1 7.15143 8.91799 1.69931 0.631991 0.791476 -0.168042 +118 1 8.1075 0.884637 1.85069 -0.145764 0.238097 -0.736312 +119 1 8.10277 0.00424992 2.71008 -1.61591 0.00687295 -1.36275 +120 1 7.06485 0.985537 2.76239 8.19773 -7.92397 -1.18231 +121 1 8.91698 1.83538 1.78872 0.656642 -0.0731624 0.0431027 +122 1 0.901335 2.58954 1.84197 -0.375827 -0.324571 -2.7055 +123 1 0.839546 1.79651 2.68072 1.09251 -0.901613 -0.242728 +124 1 0.0205195 2.75315 2.62687 -0.478759 -0.0106512 -0.67727 +125 1 1.78258 1.70562 1.69835 1.31189 0.545066 2.20675 +126 1 2.77409 2.6552 1.77928 -3.71202 0.456863 -3.25075 +127 1 2.62583 1.79361 2.77487 3.4762 0.328618 -3.48584 +128 1 1.71155 2.69761 2.62919 0.862289 -1.38539 2.38335 +129 1 3.5477 1.79572 1.86096 1.43061 -0.605958 -0.978191 +130 1 4.46749 2.5924 1.76238 -0.0494618 -0.0821277 -0.176353 +131 1 4.52929 1.74324 2.59829 -2.00749 0.662049 0.061349 +132 1 3.48188 2.69682 2.61959 1.88694 -0.141301 3.78311 +133 1 5.34711 1.71486 1.76809 1.96327 2.17405 -0.830705 +134 1 6.24637 2.73306 1.80484 3.10489 -2.12999 -0.788559 +135 1 6.31443 1.71423 2.71392 -8.21546 8.18972 -0.602972 +136 1 5.26572 2.69815 2.75971 0.0267628 0.10355 -0.216257 +137 1 7.18953 1.75159 1.71849 -0.576203 -0.36263 1.38792 +138 1 8.05027 2.77408 1.76451 0.439173 -0.587966 -0.341117 +139 1 8.01591 1.69661 2.74434 0.366947 0.0491547 0.134545 +140 1 7.14772 2.69371 2.58907 0.0738449 -1.92773 2.13155 +141 1 8.86781 3.66165 1.74517 3.90719 -1.47472 3.87657 +142 1 0.936621 4.42773 1.79512 -0.401045 -0.147867 0.321366 +143 1 0.948846 3.59531 2.72105 -0.571635 -0.0105131 -1.06193 +144 1 0.0834486 4.38982 2.63588 -0.524533 1.06652 0.75481 +145 1 1.83432 3.4799 1.75691 0.359017 0.665628 -0.818381 +146 1 2.69175 4.37077 1.75144 0.14004 0.214725 0.925417 +147 1 2.74153 3.6404 2.67912 -0.708299 -3.83642 -3.24565 +148 1 1.87968 4.54846 2.67269 -0.684796 -0.993828 -0.138535 +149 1 3.5441 3.51573 1.77434 0.186245 0.881611 -0.696526 +150 1 4.55171 4.52396 1.79145 -2.75839 -2.91024 -1.57263 +151 1 4.49896 3.65335 2.59498 -1.96388 -1.7196 0.869652 +152 1 3.49741 4.47737 2.77344 8.37692 1.8085 -7.7175 +153 1 5.44145 3.48872 1.74764 -3.05421 3.82286 1.14399 +154 1 6.1743 4.53053 1.74574 0.463366 -1.70291 0.122224 +155 1 6.30198 3.67131 2.70975 -1.07292 -0.185523 -2.51985 +156 1 5.34196 4.38653 2.7007 1.29125 2.52938 -0.102964 +157 1 7.1691 3.54339 1.87445 -0.749456 2.7751 -2.56091 +158 1 7.97266 4.40051 1.79603 0.56071 1.27489 1.72891 +159 1 7.99234 3.49992 2.67525 0.940044 2.40885 0.128516 +160 1 7.18063 4.50303 2.68825 -0.923025 -2.40154 0.0954191 +161 1 8.91159 5.33038 1.82507 -0.0203349 -0.241672 0.333237 +162 1 0.8958 6.32359 1.78851 0.38501 -0.14702 -0.347965 +163 1 0.943571 5.31749 2.71754 -0.318578 -0.34148 0.397124 +164 1 0.0864418 6.28418 2.68726 -1.86154 0.137969 -3.27119 +165 1 1.71465 5.37463 1.6949 -0.232891 -0.268012 0.301526 +166 1 2.72852 6.31988 1.88644 -2.78715 -2.37305 -5.95735 +167 1 2.64735 5.41101 2.73193 1.7471 0.192556 0.973026 +168 1 1.84919 6.27948 2.72157 -0.39498 0.808971 -0.0974847 +169 1 3.48336 5.2657 1.71665 0.625214 2.24561 1.33995 +170 1 4.39296 6.19435 1.72952 3.81534 -0.586193 2.86006 +171 1 4.52517 5.37564 2.62027 -1.99502 -0.45422 2.59567 +172 1 3.56333 6.24537 2.5877 2.83084 0.938216 3.4987 +173 1 5.32581 5.29562 1.86847 5.13697 3.80601 -2.04537 +174 1 6.24758 6.22298 1.79203 0.477004 0.378689 0.56244 +175 1 6.25283 5.44934 2.73731 1.14422 -0.830366 -0.337224 +176 1 5.45416 6.25624 2.6996 -2.42774 -1.74418 -0.22606 +177 1 7.22676 5.41803 1.71412 0.223451 -2.28899 2.0191 +178 1 8.0979 6.3518 1.78861 -0.44204 -0.435572 -0.338725 +179 1 8.01325 5.26918 2.64973 1.18264 0.878361 -0.124926 +180 1 7.11991 6.34415 2.69936 -1.3293 -2.66755 2.78128 +181 1 0.0635545 7.11209 1.72165 -0.371894 2.049 0.790012 +182 1 0.857409 8.07873 1.82753 -0.608672 -0.60495 -0.46291 +183 1 0.930573 7.24697 2.65225 -4.55248 -4.69883 0.513873 +184 1 8.8491 7.95414 2.58819 0.570786 1.09764 -0.00497061 +185 1 1.71811 7.19809 1.77835 0.893245 -0.692356 0.118249 +186 1 2.78024 8.04523 1.70672 -2.88976 2.48107 0.040135 +187 1 2.67012 7.13476 2.61708 -1.16009 2.6938 3.43626 +188 1 1.72659 7.99584 2.64342 2.19305 3.0992 -0.0129086 +189 1 3.48631 7.23394 1.84989 5.35093 -4.92393 -2.00054 +190 1 4.4261 8.04744 1.77118 -0.338387 -0.0128497 0.448007 +191 1 4.41287 7.13619 2.73708 2.81119 1.17101 -3.79683 +192 1 3.52255 7.96143 2.73527 1.04353 0.896155 0.0445218 +193 1 5.31509 7.09458 1.73703 1.75862 -0.357986 2.37379 +194 1 6.31592 8.04277 1.87992 0.07968 -0.344084 0.021952 +195 1 6.19476 7.08883 2.7194 5.13464 2.37882 -2.53303 +196 1 5.31616 7.97076 2.64032 0.139732 0.0575338 -0.0995313 +197 1 7.13779 7.0901 1.87785 -0.856279 1.84142 -1.45962 +198 1 8.00182 8.12007 1.73344 0.812689 0.333431 -0.248462 +199 1 8.01591 7.08327 2.73264 -0.0756439 0.769292 0.331432 +200 1 7.15074 8.00152 2.76416 1.82643 0.942676 -3.56152 +201 1 8.89655 8.9304 3.48678 1.65951 -0.447815 3.8493 +202 1 0.950495 0.819015 3.5162 -1.29532 1.69106 1.16913 +203 1 0.81801 0.0539921 4.51501 3.2278 -0.258036 -5.15445 +204 1 8.85177 0.90744 4.37372 14 -2.90794 10.8129 +205 1 1.78019 0.0426842 3.56938 1.84169 -0.836001 -0.350651 +206 1 2.63146 0.926366 3.57031 0.012479 0.082004 0.331715 +207 1 2.70742 0.0633514 4.41591 -1.37547 -1.33331 0.456319 +208 1 1.7142 0.801654 4.43761 0.662356 1.10176 0.272549 +209 1 3.65397 8.84382 3.54877 -3.56671 5.39916 0.463391 +210 1 4.3911 0.894602 3.52171 0.595814 -0.346452 0.321605 +211 1 4.50401 0.046887 4.49909 -1.14502 -0.949582 -0.274225 +212 1 3.51809 0.843433 4.41351 1.90854 2.37085 -0.229306 +213 1 5.34066 0.0102546 3.52427 -0.108558 0.828678 0.2339 +214 1 6.2908 0.991162 3.59141 -5.23018 -9.53106 -1.9323 +215 1 6.23033 0.0280237 4.46344 1.30838 0.516693 -1.50043 +216 1 5.29132 0.919899 4.38256 0.973507 -2.91573 1.14051 +217 1 7.06389 8.92307 3.63529 1.41369 0.894395 -0.0234904 +218 1 8.13244 0.926287 3.63848 -11.0259 -0.689673 -11.6462 +219 1 8.07431 0.0396355 4.42295 -0.0998371 -0.343464 -0.2111 +220 1 7.15426 0.902415 4.51611 0.37609 -0.87238 -0.174942 +221 1 0.0547819 1.70767 3.52402 -0.0990054 0.634623 1.9504 +222 1 0.990251 2.59589 3.64321 -1.70133 -1.15531 -1.34459 +223 1 0.876254 1.75025 4.46545 0.108846 -0.46015 0.445192 +224 1 8.851 2.6248 4.52232 3.89545 -0.330965 -5.02573 +225 1 1.83233 1.81735 3.53725 -2.40083 -0.602726 2.24699 +226 1 2.73685 2.66072 3.63237 -1.34367 -0.0545412 -0.555358 +227 1 2.76889 1.75912 4.53924 -5.46261 0.887424 -6.31803 +228 1 1.79935 2.60963 4.48075 0.43952 -0.293553 0.768966 +229 1 3.51296 1.81737 3.56522 0.159577 -1.35984 0.863711 +230 1 4.48313 2.73941 3.65804 -0.990489 -8.98093 -5.87222 +231 1 4.37894 1.70897 4.40451 -1.1595 -0.0369555 -0.272198 +232 1 3.5578 2.69572 4.44594 -0.0317478 -0.740538 0.514717 +233 1 5.41644 1.73157 3.63972 -0.214907 2.94643 -2.78853 +234 1 6.22995 2.60145 3.56616 -0.0106554 -0.60109 0.383738 +235 1 6.30303 1.6885 4.42264 -3.32083 3.037 6.44969 +236 1 5.43404 2.73282 4.52181 -0.69148 0.715375 -0.475461 +237 1 7.08666 1.7162 3.65955 7.29974 4.17951 -2.48105 +238 1 8.0318 2.68816 3.49666 -0.181832 0.425298 0.461358 +239 1 8.08432 1.70749 4.5149 -2.31295 1.75558 0.820722 +240 1 7.18431 2.71452 4.51289 0.136997 -0.067144 0.521486 +241 1 8.84691 3.61245 3.64188 4.42683 -0.879675 -3.24184 +242 1 0.916797 4.43325 3.62545 -0.842258 -0.010797 0.0107287 +243 1 0.871748 3.60004 4.51194 -0.301498 0.107107 -0.324598 +244 1 8.92426 4.51452 4.44006 -0.00859866 -1.77564 -0.547037 +245 1 1.68965 3.48331 3.5995 1.50205 1.26015 1.14935 +246 1 2.74619 4.38356 3.49878 -7.16717 1.90489 10.07 +247 1 2.74519 3.65012 4.52097 -2.02388 -3.55766 -1.13857 +248 1 1.75432 4.38414 4.53252 -0.421779 0.409337 0.409015 +249 1 3.58997 3.49254 3.52387 -0.821723 1.10659 0.0739307 +250 1 4.40569 4.52296 3.53187 0.545495 -0.966363 -0.0502063 +251 1 4.38156 3.4874 4.39271 -0.289264 8.2647 7.79533 +252 1 3.54333 4.42257 4.55563 2.80723 11.1106 -9.83606 +253 1 5.27331 3.5295 3.65482 2.61308 2.66186 -0.969787 +254 1 6.16108 4.46828 3.59956 0.599894 -1.41883 -0.240371 +255 1 6.22639 3.63251 4.44985 -0.305031 -0.480252 0.0742084 +256 1 5.31568 4.40222 4.46767 -0.344747 -0.443719 0.00587924 +257 1 7.10015 3.56367 3.49443 2.55034 0.169304 1.35525 +258 1 8.02171 4.37546 3.5697 -1.76106 3.37709 -2.28074 +259 1 8.069 3.64942 4.40708 -2.31714 -3.33053 6.18677 +260 1 7.18438 4.37135 4.52245 -1.79563 0.274401 -0.392524 +261 1 0.0758128 5.3487 3.5652 0.184463 -0.360483 0.192319 +262 1 0.795174 6.30898 3.53894 9.14413 -6.75396 2.48214 +263 1 0.867482 5.30202 4.453 0.791187 0.0370161 0.388706 +264 1 0.00225224 6.31064 4.52093 0.402626 -0.0990512 0.0415993 +265 1 1.75224 5.26394 3.64332 0.696547 0.221295 -0.114908 +266 1 2.74065 6.24856 3.64631 -0.500385 1.40459 -1.64071 +267 1 2.73855 5.4528 4.44688 -5.40773 -5.67129 2.9343 +268 1 1.74472 6.17623 4.53641 0.82995 0.717951 -0.0718944 +269 1 3.48421 5.34442 3.61728 1.66736 -1.06074 -1.09811 +270 1 4.41383 6.35055 3.60638 9.51906 -9.2799 1.43724 +271 1 4.38632 5.26464 4.48258 -0.919101 0.504742 0.900072 +272 1 3.55793 6.1617 4.49469 4.34711 2.82736 -0.340092 +273 1 5.36863 5.28325 3.49178 -0.734818 0.617922 -0.744768 +274 1 6.26503 6.19943 3.66319 0.429882 1.55809 -2.03015 +275 1 6.35487 5.3413 4.44757 0.561767 -0.978785 -0.133344 +276 1 5.27408 6.24166 4.56754 6.98603 1.54355 -5.42942 +277 1 7.19701 5.44828 3.47564 -5.73363 -4.54905 0.0826653 +278 1 7.95668 6.19688 3.55501 6.31824 5.03885 -1.22951 +279 1 8.09251 5.32103 4.3972 -0.525971 0.388914 -0.470954 +280 1 7.21521 6.34275 4.38759 -5.30552 -2.8442 0.851377 +281 1 0.0775826 7.08234 3.53581 -5.46769 7.72822 0.0708503 +282 1 0.933572 7.95134 3.59844 -0.0755868 -0.81045 -0.0294233 +283 1 0.967321 7.07254 4.42487 -1.68738 -0.0136546 1.81969 +284 1 8.87247 7.95576 4.3937 0.743652 0.272325 -0.92866 +285 1 1.76917 7.11669 3.64005 0.930468 -0.723585 -1.50003 +286 1 2.76456 8.10499 3.62233 -0.317456 0.121935 0.766743 +287 1 2.61456 7.10311 4.56718 0.759736 -0.536182 -1.28605 +288 1 1.85332 7.96709 4.49102 -0.903085 0.0612931 0.171005 +289 1 3.6668 7.06536 3.52857 -12.7314 9.15268 1.72289 +290 1 4.37522 8.04334 3.61636 3.8155 -4.43194 -0.0509001 +291 1 4.53661 7.19684 4.42303 -0.089737 0.0836956 0.326132 +292 1 3.62847 8.06443 4.56174 -6.53673 1.14979 -7.53287 +293 1 5.44626 7.09379 3.53396 -2.70855 0.0837127 2.61511 +294 1 6.30058 8.08668 3.48692 -3.50797 -0.210369 1.40313 +295 1 6.24642 7.05504 4.56658 1.23504 0.486666 -1.51311 +296 1 5.40389 8.14153 4.41484 -1.1149 -1.90428 -2.07503 +297 1 7.0793 7.23572 3.56625 0.390898 -5.13728 0.366365 +298 1 8.02564 8.11993 3.55841 -0.989908 -0.0289504 0.0817166 +299 1 7.96341 7.11444 4.5691 3.18586 3.20848 -0.902141 +300 1 7.14662 7.9965 4.39373 -0.0363915 0.663241 1.28885 +301 1 0.0665117 0.0620058 5.29566 -4.76408 0.0634028 3.8487 +302 1 0.920378 0.847838 5.33345 0.704711 1.73157 1.07432 +303 1 0.90733 0.0507073 6.29492 -0.256865 0.383558 -0.568888 +304 1 0.0695806 0.935871 6.21245 0.520609 -0.18085 0.460935 +305 1 1.7158 8.90069 5.2688 0.480844 0.845699 -0.0820744 +306 1 2.72956 0.862321 5.35582 -0.666933 0.680843 -0.243728 +307 1 2.75788 8.89573 6.26927 0.729554 0.867268 -0.717865 +308 1 1.87787 0.918127 6.17945 -0.463015 -0.230718 0.375845 +309 1 3.57292 0.0827463 5.28099 -0.282881 -3.17985 0.660183 +310 1 4.39889 0.831174 5.46088 -0.653335 9.17872 -7.1909 +311 1 4.53367 0.077487 6.1821 0.157227 -8.03625 7.38236 +312 1 3.56635 0.935389 6.31146 0.221361 0.0036999 -1.2625 +313 1 5.44773 8.84526 5.27719 -1.51548 1.46139 3.00719 +314 1 6.272 0.802404 5.33609 -0.667532 1.91594 -0.251293 +315 1 6.22537 8.89219 6.16591 -0.245349 -0.895062 1.43446 +316 1 5.33827 0.94153 6.32303 -1.13614 0.583964 -0.338203 +317 1 7.11863 0.0577427 5.44516 0.0248025 -1.55594 -0.512164 +318 1 7.97781 0.796351 5.39903 0.844611 2.54625 -2.84321 +319 1 8.06017 8.92765 6.18069 -0.104306 -2.31947 1.77241 +320 1 7.18164 0.989783 6.31023 -0.163547 -0.192109 -0.79717 +321 1 0.0916103 1.88258 5.39516 -1.00186 -1.43206 -0.661702 +322 1 0.982314 2.60245 5.42151 0.964023 2.57135 -1.73713 +323 1 0.897632 1.84422 6.25233 0.598171 -0.657266 0.69786 +324 1 0.0925235 2.7239 6.16577 -1.60764 0.211114 1.61705 +325 1 1.82959 1.77578 5.39133 -0.293694 0.755656 -0.589776 +326 1 2.69272 2.74727 5.44011 1.7292 -2.84836 -1.30998 +327 1 2.6889 1.83234 6.17525 0.647659 -0.90616 0.231454 +328 1 1.77521 2.70825 6.28078 0.536701 -0.406727 0.0293567 +329 1 3.51954 1.69427 5.29216 6.69261 0.0739574 6.33581 +330 1 4.4097 2.73314 5.34432 0.344675 0.135757 -0.187596 +331 1 4.40444 1.82369 6.16689 4.836 -4.97823 0.364517 +332 1 3.67178 2.60038 6.25743 -5.49724 5.54416 -0.00203516 +333 1 5.35146 1.77827 5.39473 -0.235283 0.213892 0.835574 +334 1 6.28399 2.77802 5.42862 -0.340126 -0.250486 -0.411738 +335 1 6.23134 1.81375 6.22687 0.0223138 0.244736 0.523936 +336 1 5.32351 2.70513 6.28288 3.08354 -1.69468 -3.77436 +337 1 7.14617 1.80036 5.35567 0.0919136 -0.311209 -0.475968 +338 1 8.0974 2.70612 5.29285 -7.26474 -2.41437 5.10983 +339 1 8.1011 1.88391 6.31294 0.0553936 -2.83177 -2.84321 +340 1 7.18351 2.67214 6.17899 0.615225 -0.197791 1.28477 +341 1 8.87232 3.47935 5.28683 2.9021 4.26792 0.541835 +342 1 0.935261 4.37233 5.44726 0.629241 0.918492 -0.917538 +343 1 0.919878 3.52494 6.23281 0.869805 0.127506 1.01894 +344 1 0.00431382 4.37186 6.33532 0.0302966 1.00444 -0.578346 +345 1 1.87251 3.50381 5.42034 -2.4415 2.77086 0.0779929 +346 1 2.70362 4.48406 5.3041 -1.90814 0.882252 2.42793 +347 1 2.75055 3.50273 6.30756 -1.47013 1.25632 -0.795276 +348 1 1.84448 4.4497 6.22456 -0.665656 -0.501499 -0.145372 +349 1 3.61741 3.6732 5.27884 1.4909 -8.59965 8.97662 +350 1 4.55362 4.53069 5.43699 -1.55164 -1.28771 -1.47171 +351 1 4.52256 3.52483 6.1944 -1.86903 1.10409 1.578 +352 1 3.65361 4.51782 6.21866 -3.39722 -3.70857 0.481797 +353 1 5.32088 3.65892 5.41856 2.55855 -1.45769 -1.45685 +354 1 6.25422 4.4123 5.33119 0.406295 0.346858 0.292537 +355 1 6.15978 3.47786 6.34128 0.227911 3.77427 -2.75081 +356 1 5.33342 4.43001 6.30433 -0.582231 -0.0994195 -0.382533 +357 1 7.19473 3.56016 5.44441 -0.898652 0.294925 -2.64663 +358 1 7.98682 4.41046 5.33513 1.4916 0.0945815 1.20731 +359 1 7.97947 3.58929 6.2697 1.92008 -1.0462 0.640867 +360 1 7.19164 4.45465 6.22659 0.298273 0.832684 -0.26134 +361 1 8.91866 5.33922 5.43231 0.972904 -0.678404 -1.89043 +362 1 0.863832 6.24178 5.44793 2.40494 -1.34388 -3.01765 +363 1 0.840212 5.37684 6.26703 1.52144 -3.32025 -2.26664 +364 1 0.0375152 6.17563 6.19921 -3.52547 2.50803 1.96141 +365 1 1.71406 5.31325 5.33193 0.359992 -0.20317 1.05182 +366 1 2.70446 6.22369 5.28953 -1.67496 -0.128385 2.17513 +367 1 2.62094 5.31478 6.20919 0.620292 0.0770975 0.0647467 +368 1 1.78318 6.16446 6.20286 -0.707464 0.30734 -0.850222 +369 1 3.5001 5.34304 5.42111 1.18155 0.33408 -1.88423 +370 1 4.48409 6.21311 5.27474 -6.47906 -0.498054 6.10955 +371 1 4.40434 5.30746 6.24861 3.30032 4.47126 1.95885 +372 1 3.65651 6.23636 6.35732 0.258101 -0.821502 -0.539452 +373 1 5.37686 5.39062 5.45706 -0.495794 0.303868 0.87367 +374 1 6.27665 6.3275 5.44876 0.578726 -4.19567 -0.915026 +375 1 6.28987 5.34918 6.28481 -0.689441 0.646514 -0.025026 +376 1 5.38856 6.30438 6.29204 -0.62461 -0.174266 -0.144794 +377 1 7.10303 5.36134 5.39788 0.303084 -0.453051 0.575398 +378 1 7.97278 6.2689 5.34555 1.29349 -0.0892034 0.239307 +379 1 8.1123 5.2681 6.25774 -0.648694 -0.661016 0.761589 +380 1 7.23419 6.34793 6.22344 -1.98134 -0.75315 1.10815 +381 1 0.0530217 7.08624 5.43675 -2.76329 0.356415 -1.34254 +382 1 0.891502 8.07734 5.33574 -0.449954 -0.433341 -0.0145848 +383 1 0.859902 7.08778 6.21702 1.22817 0.316603 2.39974 +384 1 8.86723 7.96664 6.28254 0.557062 3.16551 -3.15026 +385 1 1.77928 7.05564 5.34292 -1.2854 -0.797113 0.726349 +386 1 2.74792 8.05162 5.34603 0.580474 -0.247926 -0.00393627 +387 1 2.61984 7.13654 6.2076 0.1179 0.00397349 -0.327299 +388 1 1.73531 7.99204 6.32624 -0.619957 1.84241 -1.57732 +389 1 3.59984 7.17613 5.43634 -0.452415 0.706682 -0.14784 +390 1 4.39821 8.05962 5.28157 7.32724 0.749963 7.12774 +391 1 4.53389 7.20586 6.21186 -1.71384 -1.49003 0.809357 +392 1 3.66572 8.09269 6.23368 0.381787 -1.59697 -1.53597 +393 1 5.43811 7.11751 5.40192 -5.5589 -0.00418968 -4.06356 +394 1 6.35445 7.96959 5.31467 -2.59984 2.44569 0.360222 +395 1 6.17375 7.13942 6.18142 5.31103 3.8936 7.8957 +396 1 5.29125 8.02549 6.29493 1.99742 1.43167 0.441829 +397 1 7.11664 7.15874 5.38774 1.63444 -2.12611 -0.430051 +398 1 8.12983 8.0005 5.26693 -0.350623 0.791023 2.07438 +399 1 8.11089 7.10521 6.29529 -1.02761 -0.414645 -0.639575 +400 1 7.1542 8.04467 6.33119 -0.716395 -2.97685 -2.97233 +401 1 0.0455321 0.0581059 7.13785 -2.59331 -3.08955 0.589456 +402 1 0.853998 0.797568 7.23372 2.25232 12.9399 -9.25923 +403 1 0.893883 0.0531987 7.95582 -0.265032 -9.78891 10.4341 +404 1 0.0979374 0.927475 8.08374 -1.27945 -0.625441 0.909779 +405 1 1.70883 0.0184568 7.15475 0.947479 -0.211015 -0.0644084 +406 1 2.65212 0.910749 7.07723 -0.301347 -0.213339 -0.337826 +407 1 2.6305 8.90469 8.0727 2.55272 1.71066 0.384582 +408 1 1.75018 0.91387 8.02574 -0.526684 -0.686186 -0.483147 +409 1 3.61403 8.84934 7.06612 1.02988 1.44024 1.76178 +410 1 4.42034 0.91943 7.17223 0.522178 -1.61468 -2.10925 +411 1 4.37056 0.0516865 8.14003 0.0263315 0.189467 -0.466418 +412 1 3.59 0.934896 8.00045 0.0371044 1.00787 1.05016 +413 1 5.2816 0.0108877 7.14004 0.0410715 -0.366939 -0.311788 +414 1 6.23624 0.898837 7.05965 1.021 0.941131 0.654753 +415 1 6.246 8.87468 8.06175 -0.280098 0.535663 -1.1759 +416 1 5.31648 0.815501 8.12607 -0.78801 0.243527 -0.599256 +417 1 7.10707 8.84874 7.08197 -0.468775 2.08644 1.86713 +418 1 8.05013 0.946529 7.22788 -1.5208 -0.582053 0.186559 +419 1 8.1301 8.84043 8.01457 0.052244 0.715074 -0.282442 +420 1 7.06838 0.987221 8.03414 10.0415 -13.6791 -1.19755 +421 1 8.86835 1.70934 7.22731 2.54892 2.22649 -0.22541 +422 1 0.866325 2.76414 7.15029 -0.0137847 -2.49225 -3.8584 +423 1 0.826708 1.83336 8.03111 1.70357 -1.53255 0.309164 +424 1 0.0511912 2.65175 8.02861 -1.53037 1.53618 -0.152554 +425 1 1.7237 1.71044 7.1133 -0.3904 -0.435435 -0.731182 +426 1 2.66636 2.72018 7.14295 0.547793 -0.274295 0.648117 +427 1 2.70105 1.80209 8.13576 -0.0852062 -0.133841 -0.000493208 +428 1 1.77492 2.76081 8.10399 0.564357 -0.308093 0.985398 +429 1 3.66205 1.87543 7.16799 0.15905 -2.5091 -2.55207 +430 1 4.55348 2.70177 7.05301 -5.50098 -2.53366 3.01389 +431 1 4.46818 1.71608 7.96441 0.32513 1.80226 3.00161 +432 1 3.56091 2.58808 8.02945 0.396266 1.95642 2.12785 +433 1 5.36149 1.84637 7.16969 0.516803 -0.0610583 -0.802699 +434 1 6.28291 2.77184 7.1854 -0.512674 -3.17359 2.22694 +435 1 6.3427 1.71551 7.9726 -15.2061 11.4078 1.6664 +436 1 5.45463 2.61593 8.09933 0.73198 1.12429 -0.810915 +437 1 7.14617 1.80598 7.24022 4.03182 0.503759 -4.81039 +438 1 8.07521 2.6756 7.07092 -0.336894 3.22322 3.478 +439 1 8.11875 1.8373 8.10797 -1.57974 -0.493075 -0.537868 +440 1 7.09714 2.63714 8.02739 -0.0173147 0.820696 1.90431 +441 1 8.85027 3.56499 7.15253 3.00565 -1.27064 -0.682205 +442 1 0.885235 4.38222 7.18774 -1.842 1.22146 -0.226395 +443 1 0.884771 3.48141 7.97536 -0.530218 4.3971 3.23625 +444 1 0.0419078 4.41462 8.04436 -0.806344 -0.262731 -0.956831 +445 1 1.73746 3.66699 7.09267 1.85773 -3.96877 -1.41987 +446 1 2.66489 4.55163 7.19564 0.399017 -1.47837 -0.325749 +447 1 2.68401 3.61278 8.06372 0.262338 -0.0680464 0.329915 +448 1 1.80878 4.38262 7.9551 -1.46544 1.49945 2.09645 +449 1 3.55441 3.63471 7.17184 -0.0924634 0.45212 0.606799 +450 1 4.40759 4.53436 7.23701 0.160045 0.252781 -1.03281 +451 1 4.47938 3.49218 8.04219 0.177099 0.0940276 0.00712601 +452 1 3.55379 4.48752 8.06012 -0.927856 0.341505 -0.0833457 +453 1 5.30335 3.52949 7.1279 2.00125 1.71282 0.0663191 +454 1 6.19233 4.44015 7.09395 -0.123778 -0.82645 0.684973 +455 1 6.31698 3.55227 8.05766 -1.80584 -0.932697 -1.1518 +456 1 5.41804 4.43351 8.09204 -4.30063 -0.218755 -3.96516 +457 1 7.232 3.50321 7.24512 -0.569054 0.129485 -1.05452 +458 1 8.04777 4.39134 7.10023 -0.415559 1.27013 1.1937 +459 1 8.09921 3.54644 7.99275 -0.904288 0.185761 1.62031 +460 1 7.15284 4.38151 8.0646 -0.281528 0.0795406 -1.17401 +461 1 8.85944 5.36104 7.19522 1.71386 -0.372777 -2.67299 +462 1 0.808445 6.15874 7.05432 0.343929 1.70028 2.25424 +463 1 0.99266 5.36055 8.05319 -1.96195 -0.361049 -1.35199 +464 1 8.9228 6.22111 8.03716 -0.328906 0.253391 -0.16959 +465 1 1.7511 5.27554 7.16317 -0.501838 -0.493478 -1.59379 +466 1 2.7323 6.31099 7.08452 0.463177 0.0720173 0.389338 +467 1 2.75106 5.38162 8.09911 0.530948 -0.923774 -0.761524 +468 1 1.80446 6.33727 8.00982 0.567564 -0.353842 0.999402 +469 1 3.53218 5.32026 7.15711 1.3552 1.44822 0.141569 +470 1 4.49512 6.19462 7.20137 -2.95094 2.57244 -4.09211 +471 1 4.4829 5.43783 8.04952 -1.75843 -3.70774 -0.194014 +472 1 3.65767 6.24252 7.97233 -2.18137 -0.334806 -0.189717 +473 1 5.35752 5.46295 7.14871 1.05371 -2.23541 -1.50951 +474 1 6.22804 6.29485 7.12141 -0.370188 0.264704 -0.149428 +475 1 6.34127 5.4593 8.01496 -0.759119 0.239406 -0.0100712 +476 1 5.27101 6.21963 7.98358 4.21356 3.70888 3.53999 +477 1 7.2413 5.39744 7.15422 0.63332 0.408861 0.0765336 +478 1 8.01209 6.33115 7.20214 1.04149 -1.50251 -0.643312 +479 1 8.11155 5.33363 8.02803 -2.08279 1.51127 0.153008 +480 1 7.20203 6.31049 8.06426 -0.105023 -0.935886 0.140492 +481 1 8.92362 7.24394 7.10015 0.0792153 -3.18157 4.09933 +482 1 0.865164 8.02092 7.22606 2.85769 1.65383 -2.61434 +483 1 0.86745 7.15339 8.01815 -0.578541 -0.380635 0.364655 +484 1 0.0284189 8.08161 7.95725 -0.890268 -0.349283 1.10066 +485 1 1.85656 7.22057 7.11535 0.397315 -1.70504 3.16253 +486 1 2.77375 7.96501 7.15423 0.0953595 0.0574297 -0.272157 +487 1 2.64437 7.22314 8.11966 1.48696 -0.179689 -2.12782 +488 1 1.85941 8.11413 7.96635 -2.35368 -2.50728 -0.754549 +489 1 3.67468 7.10829 7.12824 0.65987 0.70298 0.656082 +490 1 4.46621 7.99739 7.2078 2.25404 -0.456947 -2.59682 +491 1 4.48001 7.09955 8.01357 0.0334801 0.324585 -0.290932 +492 1 3.6378 8.02597 7.95299 -1.96867 -0.619231 2.20677 +493 1 5.31589 7.17259 7.15585 0.23145 -0.930936 -0.437425 +494 1 6.20936 8.03122 7.09513 -0.13604 -0.296447 0.152582 +495 1 6.17543 7.22187 8.09898 5.44884 -7.61495 -1.62058 +496 1 5.43883 7.98222 8.0181 -6.37262 6.00913 -1.00537 +497 1 7.14576 7.09705 7.14015 0.407174 1.49093 0.0363952 +498 1 8.02588 8.07609 7.1284 1.43118 -1.40285 -0.689018 +499 1 7.99317 7.15919 8.00286 1.19218 0.601266 0.682892 +500 1 7.2435 8.04597 7.97482 -1.89044 -0.246287 0.1524 +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +500 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 8.5498797333834844e+00 +0.0000000000000000e+00 8.5498797333834844e+00 +0.0000000000000000e+00 8.5498797333834844e+00 +ITEM: ATOMS id type x y z f_1[1] f_1[2] f_1[3] +1 1 0.0109462 8.52194 8.48789 1.60777 3.16074 4.93288 +2 1 0.770239 0.886587 0.0775241 5.1148 0.619933 -4.35337 +3 1 0.914855 8.54009 0.795212 -2.54709 2.40671 3.27622 +4 1 8.53949 0.79582 0.824294 -1.87361 -0.316163 2.22706 +5 1 1.68126 8.45058 8.49491 -0.796772 17.9401 13.8601 +6 1 2.49257 0.906431 0.000759221 8.8197 -0.476032 2.96817 +7 1 2.62932 0.0354753 0.888378 -4.43263 -0.45206 -5.76212 +8 1 1.71329 0.913566 0.778252 -3.74188 -4.37189 3.26227 +9 1 3.42175 0.0965993 8.49503 -4.75784 -8.08943 10.1901 +10 1 4.21271 0.889278 8.46971 8.07159 3.26979 7.09905 +11 1 4.30903 0.0721078 0.771319 -2.20196 2.16322 3.01896 +12 1 3.42332 0.912751 0.876126 -1.2014 -0.27869 -2.68959 +13 1 5.04057 8.48132 8.46735 12.114 4.06773 4.60111 +14 1 5.95626 0.830289 0.0884189 2.64036 5.56585 -7.9642 +15 1 5.95178 0.0392781 0.802073 0.496214 -5.11156 5.55524 +16 1 5.1151 0.919125 0.80056 -4.53937 -3.75487 2.57161 +17 1 6.8031 8.46299 8.54479 -1.12262 1.88258 -1.67969 +18 1 7.77702 0.837169 8.46101 -2.81144 0.601723 4.97774 +19 1 7.61766 0.0190488 0.807902 2.02145 -3.01975 -0.996798 +20 1 6.83813 0.841817 0.893784 2.20091 1.15146 -3.46095 +21 1 0.00483518 1.7748 8.45086 3.14001 0.0124508 7.14446 +22 1 0.925315 2.54775 8.47859 -2.14676 3.17757 1.68537 +23 1 0.946475 1.73152 0.932031 -7.90083 -3.0997 -5.49951 +24 1 0.0820864 2.59152 0.95052 -16.5003 -1.1863 -19.4267 +25 1 1.62363 1.68342 8.4651 1.8496 1.86303 2.33818 +26 1 2.56251 2.66233 0.0202936 -6.7309 -4.60627 -0.0436147 +27 1 2.47347 1.71611 0.900003 2.27232 1.93928 0.205074 +28 1 1.66562 2.5538 0.89239 8.29789 -0.0162708 -2.14995 +29 1 3.47808 1.70927 8.49067 -6.21947 -0.00998514 1.91211 +30 1 4.19294 2.51037 0.0787296 16.1199 8.28753 -17.6776 +31 1 4.29711 1.73051 0.787489 0.142042 -5.75402 7.11231 +32 1 3.43681 2.6439 0.75999 -11.309 -9.11906 21.9869 +33 1 5.20599 1.76704 0.0398807 -10.2389 -11.7619 -5.76949 +34 1 5.91436 2.52733 8.51501 10.4145 9.83206 -1.49498 +35 1 5.9033 1.67223 0.919622 10.1161 4.25667 -5.1777 +36 1 5.15205 2.55373 0.788133 -1.76953 2.31199 6.90362 +37 1 6.92232 1.70971 0.0701593 -2.50899 -1.62202 -0.822044 +38 1 7.5955 2.61765 0.0592135 2.55821 0.640647 0.0382532 +39 1 7.74881 1.7729 0.896218 -1.59166 -5.96851 -6.46077 +40 1 6.80231 2.56106 0.910949 5.84287 -4.44794 -4.99646 +41 1 0.028349 3.48236 8.49963 2.5025 -5.04288 3.39467 +42 1 0.836484 4.27887 0.0816773 0.760548 2.93196 -2.43461 +43 1 0.942186 3.3633 0.783926 -3.69777 5.09684 -0.0674025 +44 1 8.51583 4.33027 0.838505 2.60137 -0.826864 1.21094 +45 1 1.65067 3.4812 8.47243 0.730068 -2.57113 1.91442 +46 1 2.5668 4.2649 8.54781 -0.773361 3.29166 6.51609 +47 1 2.51515 3.35935 0.92744 0.397687 12.5391 -13.0985 +48 1 1.73465 4.30243 0.83421 -1.47193 -2.67124 0.923933 +49 1 3.37869 3.37397 0.0291446 3.12688 15.3224 -6.53558 +50 1 4.34738 4.34434 0.00829503 -5.52046 -6.93359 -2.07611 +51 1 4.32411 3.36572 0.836745 -2.16657 1.87946 3.00206 +52 1 3.33524 4.20214 0.9322 3.17725 3.34929 -6.83564 +53 1 5.08499 3.41929 0.036632 4.03928 -2.58738 -4.81317 +54 1 6.04127 4.33974 8.49644 -0.624803 -0.102814 0.982479 +55 1 6.01611 3.33685 0.909561 -5.08671 5.06768 -6.62403 +56 1 5.207 4.2377 0.760733 -1.32975 0.891019 3.81461 +57 1 6.81304 3.47817 0.0178755 -0.843928 -8.06693 -2.50137 +58 1 7.73203 4.2048 0.00740382 -1.99245 1.66716 -1.57857 +59 1 7.78831 3.44874 0.953497 -3.78613 -1.03229 -4.77194 +60 1 6.90781 4.17709 0.825008 -1.46363 4.64194 5.22986 +61 1 8.46845 5.09622 8.47404 12.6898 1.90364 12.9104 +62 1 0.797366 5.93181 8.52222 2.38416 2.33873 2.4531 +63 1 0.806155 5.19524 0.885366 4.86564 -4.44474 -2.27198 +64 1 0.0123025 5.95271 0.830227 -4.90982 1.72838 0.59014 +65 1 1.70825 5.09756 8.50872 2.27411 3.17124 11.7261 +66 1 2.57892 5.99612 8.47434 -1.64581 0.780097 1.78814 +67 1 2.53606 5.08073 0.912891 1.82428 2.12405 0.338003 +68 1 1.76245 6.06361 0.855052 -0.817516 -1.26047 -0.587481 +69 1 3.36815 5.1611 0.0892763 -1.75416 -1.94918 -4.15038 +70 1 4.34388 5.99478 8.53994 -9.12199 -5.82315 -0.643131 +71 1 4.22842 5.14974 0.779802 4.93843 -0.926739 3.98855 +72 1 3.45177 5.94376 0.905424 -5.40353 3.18508 -3.48186 +73 1 5.06545 5.13306 8.4631 8.02458 6.68819 3.23791 +74 1 5.91929 6.01015 8.53548 3.77131 -1.20656 -2.03594 +75 1 5.88805 5.11842 0.816496 5.73582 1.96394 -4.01157 +76 1 5.18785 6.02276 0.820364 -9.36617 -3.77225 -2.84856 +77 1 6.8933 5.1517 8.49766 -1.10898 -0.445881 0.788116 +78 1 7.73242 5.99103 8.48869 1.48322 -7.68495 9.10162 +79 1 7.66553 5.0457 0.7869 0.413505 3.32493 1.60624 +80 1 6.9298 5.9353 0.896867 -3.44217 0.759559 -1.89572 +81 1 0.0757853 6.76414 0.08264 -2.09776 5.63137 -2.35842 +82 1 0.929754 7.68563 0.0937614 -14.24 2.10473 -10.1605 +83 1 0.947372 6.93568 0.898093 -37.7638 -41.2899 -5.14895 +84 1 0.0463649 7.75037 0.902481 -0.259219 -2.38896 -3.08434 +85 1 1.64115 6.89463 8.52754 6.28385 -7.53573 1.49633 +86 1 2.53763 7.75472 8.45351 15.1175 -6.89071 16.4408 +87 1 2.60347 6.88355 0.853331 -4.53589 -3.86491 -4.69681 +88 1 1.61173 7.63221 0.905993 43.7793 33.7511 -1.13346 +89 1 3.3813 6.82692 8.54355 -0.238432 1.95456 2.34043 +90 1 4.24371 7.77989 0.043504 -5.67067 -7.72392 -1.84442 +91 1 4.1828 6.86814 0.818276 1.21815 -0.827933 0.630987 +92 1 3.3368 7.7382 0.923275 7.52639 -2.01137 -4.72269 +93 1 5.071 6.7563 0.010658 5.49209 11.6713 -3.15323 +94 1 5.90188 7.6356 0.0424163 1.86621 0.862931 -1.97936 +95 1 6.03172 6.8673 0.938495 -1.34369 1.09475 -9.39496 +96 1 5.15248 7.77523 0.857214 -2.90101 -1.73408 2.05686 +97 1 6.89959 6.76423 0.01648 -11.1028 0.34724 0.750719 +98 1 7.65506 7.70409 0.0429309 2.74021 -1.34663 -2.67212 +99 1 7.64597 6.8087 0.792436 6.14337 0.285334 5.54838 +100 1 6.81299 7.61529 0.784654 1.50923 3.73377 2.87701 +101 1 0.039157 8.46192 1.76149 -3.85041 1.88762 -2.12951 +102 1 0.799188 0.819633 1.69376 4.21763 0.723161 -3.63495 +103 1 0.763005 0.0408753 2.55669 11.5628 -1.30287 -1.53659 +104 1 0.0652633 0.934891 2.49039 -5.1145 -1.67274 5.33691 +105 1 1.66381 8.45402 1.66249 1.87623 5.22247 1.17986 +106 1 2.503 0.802578 1.65731 0.0918423 3.77669 3.70231 +107 1 2.51579 0.0135642 2.53917 0.463256 0.0266605 -0.815012 +108 1 1.65685 0.926197 2.57259 5.9178 -9.1905 -0.306187 +109 1 3.4242 0.0443963 1.67808 1.33331 -0.794171 2.32841 +110 1 4.23298 0.877511 1.6619 2.15651 0.36791 0.599305 +111 1 4.23114 8.48221 2.59613 0.139704 5.19667 3.26797 +112 1 3.42382 0.825355 2.52764 0.831325 -0.597344 0.750298 +113 1 5.10755 0.098598 1.64667 1.13835 -0.15217 0.418453 +114 1 6.07979 0.861483 1.66377 -9.38879 -3.1028 5.61252 +115 1 6.06362 0.0403691 2.64895 -6.98521 -8.98289 -11.9164 +116 1 5.20913 0.939312 2.59362 -1.28414 -1.16831 -2.67638 +117 1 6.75529 8.52816 1.79359 4.36806 -0.709446 -4.01445 +118 1 7.76101 0.764033 1.62558 -1.73868 3.93794 4.49945 +119 1 7.66206 0.0708021 2.53607 1.47505 -2.32899 1.29594 +120 1 6.92286 0.947435 2.52138 -4.88314 -16.5943 7.22153 +121 1 8.51449 1.72985 1.71942 6.76951 -3.05423 -0.995536 +122 1 0.834691 2.62553 1.61171 16.0236 -0.437826 23.4167 +123 1 0.945534 1.71145 2.53519 -17.6422 5.766 10.6769 +124 1 8.53575 2.60321 2.48391 2.61084 -9.58061 10.2444 +125 1 1.63294 1.72028 1.76938 14.1815 -0.440268 -11.5313 +126 1 2.57682 2.65502 1.67415 2.8611 -15.9615 10.724 +127 1 2.65189 1.65955 2.48962 -4.47742 1.085 2.58429 +128 1 1.79145 2.49644 2.55538 0.0425348 2.96537 1.56716 +129 1 3.45687 1.73281 1.73911 -3.75938 -0.279924 -8.91417 +130 1 4.34908 2.51749 1.7514 -3.12574 5.69408 -7.34516 +131 1 4.21985 1.73239 2.48294 4.56177 -5.44217 8.83153 +132 1 3.39941 2.5984 2.48766 0.0932155 -0.49927 3.02478 +133 1 5.22539 1.80308 1.7328 -5.21779 -2.43895 2.23844 +134 1 6.07426 2.60134 1.71356 -9.82102 -9.11759 6.53349 +135 1 6.06098 1.72463 2.48049 -24.0059 1.32147 25.9525 +136 1 5.04217 2.48583 2.60699 6.13261 3.37855 2.31458 +137 1 6.77443 1.68358 1.80416 26.2694 11.8834 -33.3324 +138 1 7.78345 2.52468 1.65191 -10.0717 7.23238 6.81167 +139 1 7.67217 1.70427 2.51662 7.38759 5.50979 0.483479 +140 1 6.87655 2.54802 2.65887 0.828003 6.30102 -11.6733 +141 1 8.48905 3.38009 1.79052 3.95862 11.358 -4.16794 +142 1 0.904648 4.31805 1.73458 -1.64595 0.0791848 -3.59387 +143 1 0.882159 3.48871 2.5578 -1.47386 -2.40831 0.515883 +144 1 0.0640856 4.36164 2.51005 -1.54232 -2.6948 -1.06039 +145 1 1.78366 3.38548 1.78248 -8.79706 -1.19951 -6.15917 +146 1 2.61647 4.18826 1.75601 -13.6767 13.2656 0.0962066 +147 1 2.49967 3.46972 2.59724 11.287 -7.88562 -0.187146 +148 1 1.72994 4.21494 2.4741 -1.76295 10.5241 6.69302 +149 1 3.35408 3.46945 1.74549 12.0923 -11.3982 2.63093 +150 1 4.33371 4.2573 1.65266 -1.0572 -0.0681575 -0.357999 +151 1 4.25135 3.37501 2.62082 -0.724851 2.23609 -3.08367 +152 1 3.37046 4.34755 2.6064 0.218455 -8.01846 -3.14612 +153 1 5.16664 3.3978 1.80383 -2.26051 -2.46633 -4.30603 +154 1 6.02075 4.21565 1.63908 -0.444656 2.88859 -0.464916 +155 1 6.04443 3.46025 2.46975 -2.50911 -3.21487 7.82311 +156 1 5.06457 4.21348 2.57808 1.01082 5.99339 -2.31274 +157 1 6.80721 3.3694 1.6818 12.0846 7.00158 1.77966 +158 1 7.66426 4.31037 1.75089 1.93845 -1.12426 -1.15071 +159 1 7.67666 3.35746 2.66226 0.0349977 1.35377 -1.51011 +160 1 6.86746 4.18845 2.58559 1.34212 2.76274 1.29577 +161 1 0.0121787 5.21746 1.67805 -1.66136 -3.05338 2.49187 +162 1 0.848043 6.06063 1.634 -1.152 -1.54074 2.03353 +163 1 0.891535 5.1714 2.53903 -1.80088 0.0367987 2.5043 +164 1 8.53141 6.02479 2.48115 1.46529 0.600203 2.28151 +165 1 1.67096 5.18637 1.75513 2.90335 -0.353263 -4.03581 +166 1 2.63344 6.0279 1.70432 -16.3644 -8.57778 -6.55322 +167 1 2.48532 5.10477 2.59913 0.462017 -0.718364 -1.79537 +168 1 1.74617 5.95248 2.59859 0.0442724 3.34654 -0.327538 +169 1 3.3871 5.11741 1.76498 -0.70902 0.100622 -1.55997 +170 1 4.23897 5.91622 1.65627 3.82091 1.24022 3.5679 +171 1 4.18272 5.19526 2.64844 4.07887 -0.154168 -2.99301 +172 1 3.33243 6.04257 2.48749 13.2178 -9.29314 8.76503 +173 1 5.21355 5.13048 1.6694 -5.38913 -0.724028 1.81762 +174 1 5.88731 6.04999 1.61164 27.08 -23.484 7.87668 +175 1 5.91685 5.19555 2.55373 8.22272 -5.32197 -1.91553 +176 1 5.22513 6.01752 2.48789 -6.37641 3.03262 4.81469 +177 1 6.87923 5.14396 1.75241 -1.31228 -0.52571 -0.175031 +178 1 7.66325 6.00346 1.75398 1.55065 0.721262 -1.56625 +179 1 7.71088 5.21107 2.64045 -0.197441 -3.63935 -3.47269 +180 1 6.81367 6.03163 2.50271 -0.887486 -5.65654 8.47366 +181 1 8.45469 6.86312 1.68381 5.32955 -1.93357 -1.0964 +182 1 0.887234 7.64699 1.70441 -8.03342 4.67955 6.65869 +183 1 0.827773 6.84361 2.49826 0.666014 -0.927683 2.41577 +184 1 0.0243326 7.6531 2.64337 -2.41729 -1.59288 -7.26092 +185 1 1.67566 6.82407 1.70759 6.3287 0.149047 4.42322 +186 1 2.51454 7.65687 1.63227 -3.24159 2.2536 7.24906 +187 1 2.61047 6.80534 2.59521 -8.48569 7.62473 -2.75927 +188 1 1.62469 7.75189 2.55083 1.70283 -3.32336 -0.400725 +189 1 3.32845 6.81114 1.68061 10.3844 9.25335 0.5217 +190 1 4.35781 7.7751 1.79868 -7.49989 -3.23754 -13.7369 +191 1 4.19243 6.92819 2.60428 15.2501 -13.591 -1.36339 +192 1 3.43706 7.60555 2.52571 -13.7857 14.6138 -0.968483 +193 1 5.20185 6.77695 1.66316 -21.9331 19.6829 3.32007 +194 1 5.90138 7.62608 1.77842 3.59956 5.50204 -2.20333 +195 1 5.95566 6.93899 2.64467 1.5684 -14.0837 -9.48217 +196 1 5.06902 7.62841 2.55428 6.74225 1.46675 8.63059 +197 1 6.76742 6.8085 1.78801 1.36869 6.36826 -6.59728 +198 1 7.65843 7.62584 1.68675 -2.22178 4.8322 -2.62428 +199 1 7.67415 6.89867 2.52463 2.21143 -5.15334 3.5596 +200 1 6.87662 7.66202 2.55284 -3.26152 2.73313 1.32325 +201 1 0.0405641 8.51038 3.32948 -5.92557 3.54592 8.59039 +202 1 0.809165 0.908392 3.38948 1.71953 -1.70344 0.923667 +203 1 0.901714 8.46653 4.19384 -9.71216 4.93867 8.34322 +204 1 0.069999 0.928448 4.31429 -4.27362 -2.53344 -6.14786 +205 1 1.6264 8.4509 3.42354 8.98155 6.03203 -6.76996 +206 1 2.65602 0.762944 3.43842 -5.54094 5.64927 -11.0802 +207 1 2.61793 0.0468587 4.22961 -1.55064 -6.54911 6.6458 +208 1 1.68094 0.888048 4.32275 0.711784 -4.72688 -3.71581 +209 1 3.43429 8.45723 3.40115 7.64008 12.4108 0.619842 +210 1 4.23416 0.880739 3.42582 5.39503 -6.32873 -0.402512 +211 1 4.18642 8.4609 4.33191 11.6244 16.7018 2.29066 +212 1 3.36155 0.898574 4.22656 4.93072 -1.64922 5.55995 +213 1 5.13206 0.0787666 3.45034 -0.945527 -3.11163 -2.8253 +214 1 6.05542 0.815095 3.33818 0.680768 11.3265 10.7561 +215 1 5.88615 0.068379 4.32153 11.9175 -9.57172 -8.45948 +216 1 5.21525 0.885851 4.19789 -5.15816 5.54694 4.34946 +217 1 6.80589 8.45257 3.40423 5.88256 0.0541198 6.21084 +218 1 7.74454 0.870555 3.46229 0.501904 -4.05279 -5.44709 +219 1 7.62711 0.0144156 4.35804 1.95636 -0.757148 -6.431 +220 1 6.7475 0.756319 4.34542 2.82117 3.60456 -0.442947 +221 1 0.046471 1.74765 3.48426 -2.94726 0.460616 -2.28233 +222 1 0.888532 2.54472 3.37968 0.966992 1.17998 0.546373 +223 1 0.832134 1.79852 4.28422 5.1168 -14.8036 -11.8055 +224 1 0.0855384 2.60849 4.37243 -9.37894 3.13224 -11.0091 +225 1 1.76053 1.64213 3.45381 -3.40447 2.71972 -2.85028 +226 1 2.52635 2.61582 3.43297 3.65437 -1.51294 -3.08517 +227 1 2.50122 1.75788 4.25552 8.72555 -0.689386 -1.86072 +228 1 1.75205 2.6278 4.21833 -8.89154 -5.54607 2.69229 +229 1 3.50205 1.65486 3.36684 -7.50491 6.39615 -0.836562 +230 1 4.28152 2.60594 3.4252 -1.76945 -2.76432 2.53661 +231 1 4.17705 1.67239 4.28707 6.76533 -1.25356 -1.29705 +232 1 3.44438 2.47178 4.25656 -4.81944 5.002 -0.576402 +233 1 5.22486 1.68937 3.43619 -3.28026 2.78772 -4.39101 +234 1 6.02069 2.55292 3.33778 -3.72236 0.507942 3.01424 +235 1 5.96152 1.77008 4.23889 4.98563 -0.248026 3.40967 +236 1 5.17107 2.61009 4.24734 -0.598251 0.473097 -0.376582 +237 1 6.87337 1.72985 3.32607 -2.78397 -6.76638 7.83701 +238 1 7.692 2.50127 3.44714 2.52098 2.71173 -0.194497 +239 1 7.63531 1.64894 4.19535 0.881487 3.19892 6.53537 +240 1 6.92924 2.5559 4.32195 -3.68781 1.74243 -2.92343 +241 1 0.0154582 3.42553 3.38818 0.573657 0.250438 1.11994 +242 1 0.946668 4.34133 3.49534 -14.1263 -16.7645 -9.90419 +243 1 0.911751 3.43019 4.31621 -0.850264 0.755291 -1.68921 +244 1 0.0046042 4.25775 4.34424 -1.31738 -1.24756 -1.54253 +245 1 1.76086 3.48229 3.3966 -12.418 -8.98763 3.21891 +246 1 2.48605 4.22978 3.40508 14.0841 10.3397 -4.15997 +247 1 2.54799 3.33831 4.30225 4.92033 13.8543 -7.00111 +248 1 1.7676 4.3622 4.17566 0.280546 -16.6448 26.3844 +249 1 3.37038 3.45998 3.42173 -0.200746 -1.45028 -1.29578 +250 1 4.20874 4.30541 3.50172 4.65367 -11.48 -19.1828 +251 1 4.21154 3.43635 4.23457 4.19917 -3.40534 2.03948 +252 1 3.45806 4.23712 4.25878 -8.55751 2.75292 6.08306 +253 1 5.11168 3.47839 3.3691 -0.311412 -5.69502 5.70804 +254 1 5.92148 4.26406 3.41002 5.13821 -1.04796 0.0327238 +255 1 6.02264 3.46008 4.23226 -3.02748 -3.55814 1.41554 +256 1 5.17114 4.24863 4.35423 -2.77791 4.93248 -13.0008 +257 1 6.86557 3.34851 3.50434 -4.54964 -0.0741147 -9.06001 +258 1 7.67607 4.29403 3.50495 4.02814 6.65377 -10.7943 +259 1 7.67432 3.49417 4.17544 8.6417 -11.3672 14.2425 +260 1 6.8466 4.22166 4.23144 -3.46256 4.46394 4.938 +261 1 0.0814499 5.05812 3.37338 -2.94602 3.43381 2.0972 +262 1 0.952662 5.9924 3.43554 -2.60446 0.4469 0.54362 +263 1 0.765082 5.07607 4.26673 5.31334 4.0071 5.5605 +264 1 0.0672914 5.95184 4.29838 -1.77164 3.23629 -2.96482 +265 1 1.64676 5.09677 3.49021 9.45599 25.7387 -15.7709 +266 1 2.59524 6.06011 3.441 -1.69946 -11.0916 -4.14222 +267 1 2.46878 5.21999 4.3176 5.41184 -22.6386 -22.4739 +268 1 1.72435 5.99765 4.33067 -8.961 3.18884 -2.81076 +269 1 3.33576 5.13502 3.32819 -1.95672 4.97188 10.3591 +270 1 4.33219 6.01601 3.4905 -3.43576 -1.4684 -1.43775 +271 1 4.2868 5.05318 4.19611 2.54498 12.874 12.0539 +272 1 3.47487 5.92769 4.31716 -1.095 0.823289 -0.856965 +273 1 5.22135 5.10776 3.40172 -8.93936 2.06172 1.30023 +274 1 6.0405 5.92456 3.43523 0.724841 2.24513 0.144002 +275 1 5.92006 5.1314 4.26005 8.25611 -3.42587 -2.20917 +276 1 5.11155 5.91401 4.29084 1.00396 1.28478 -0.181662 +277 1 6.86476 5.07118 3.47111 -5.70253 1.83988 -3.65428 +278 1 7.60709 5.97166 3.43329 1.57958 3.02153 1.22094 +279 1 7.62121 5.17116 4.25108 13.415 -9.76593 -1.32536 +280 1 6.90725 5.93696 4.35438 -12.0061 10.5099 -5.89092 +281 1 0.0158532 6.88433 3.5005 2.50125 -3.66413 -3.15884 +282 1 0.832759 7.6858 3.39159 0.810583 -3.83454 1.16734 +283 1 0.879361 6.87893 4.25184 1.06811 -4.80567 -3.71366 +284 1 8.48025 7.67569 4.32838 6.71448 4.3067 1.89144 +285 1 1.76699 6.83608 3.37875 -3.92913 2.06189 -0.762911 +286 1 2.64337 7.79272 3.38564 -11.5742 -11.6301 0.504133 +287 1 2.51611 6.79594 4.20547 2.9771 6.7763 8.40555 +288 1 1.73472 7.75634 4.30153 3.5376 -4.65751 1.06495 +289 1 3.42458 6.78486 3.36363 0.711862 2.92454 6.30952 +290 1 4.29146 7.78029 3.51531 3.92856 -8.43358 -6.61451 +291 1 4.22796 6.89496 4.356 2.49253 -3.58746 -4.19183 +292 1 3.49073 7.69895 4.31251 -15.4332 -7.21194 0.0843114 +293 1 5.03295 6.88949 3.43613 2.4132 0.715094 1.20127 +294 1 5.9914 7.60738 3.43115 0.166605 10.2994 10.8333 +295 1 6.06057 6.76316 4.28526 -0.682389 0.774521 0.518315 +296 1 5.1506 7.68481 4.35956 -0.587179 -0.831286 -4.17718 +297 1 6.91829 6.87557 3.41173 -2.20287 0.087574 0.74732 +298 1 7.77376 7.66664 3.47631 -5.20912 2.94829 -3.10686 +299 1 7.7733 6.85147 4.2793 -6.28798 -5.26886 2.97867 +300 1 6.79627 7.70864 4.34123 1.13479 0.471756 -2.41754 +301 1 8.47537 0.0666715 5.07785 3.07732 -2.35936 2.36099 +302 1 0.837862 0.824189 5.08442 2.67015 -0.0526079 4.2528 +303 1 0.947354 8.53746 5.97515 -9.44477 -2.06512 3.38353 +304 1 8.45527 0.903487 5.90211 4.35699 -8.49334 13.6006 +305 1 1.71466 0.0614796 5.21675 1.71751 -10.7388 -14.8483 +306 1 2.56545 0.785351 5.1483 1.0332 2.19745 -1.75997 +307 1 2.58448 8.48208 5.91956 0.430753 0.76971 3.58164 +308 1 1.65003 0.816215 5.93197 3.03102 12.7849 8.36083 +309 1 3.46033 0.0141985 5.16494 -4.25366 -0.783326 -0.484155 +310 1 4.20213 0.929517 5.13838 2.42665 -3.78185 -0.152962 +311 1 4.26733 0.0836521 5.92638 3.25998 -1.091 1.74874 +312 1 3.41102 0.861262 6.03148 -0.949591 0.0559607 -1.66554 +313 1 5.1564 8.53616 5.06672 -11.5945 -0.673098 9.37255 +314 1 5.94115 0.761043 5.20173 4.62182 33.122 -29.3364 +315 1 5.93463 0.0696556 5.8868 1.75697 -30.8547 30.3151 +316 1 5.14065 0.9256 5.95741 -0.006185 -4.789 2.4932 +317 1 6.91953 8.50208 5.18386 -10.6338 4.52372 2.129 +318 1 7.72317 0.898909 5.10883 -6.55365 -0.206627 -4.30053 +319 1 7.67728 0.0288812 5.99182 2.50541 0.776267 0.642418 +320 1 6.91834 0.891409 5.91811 -4.13582 -0.84176 -0.41985 +321 1 0.0355634 1.62397 5.15959 0.786537 13.0999 -7.10363 +322 1 0.855042 2.4658 5.05819 10.8208 10.8619 21.426 +323 1 0.798893 1.71459 6.01685 5.79471 -4.43182 -0.915803 +324 1 0.0659206 2.49237 5.91102 -5.57064 6.4328 0.916789 +325 1 1.77633 1.69788 5.04117 -5.55508 3.43302 7.46453 +326 1 2.55086 2.64298 5.08873 0.0193134 -8.77259 6.85672 +327 1 2.49765 1.63315 5.92814 1.12021 1.50275 1.88199 +328 1 1.80539 2.621 5.95731 -6.21714 -3.35524 -0.269961 +329 1 3.34329 1.63256 5.07699 -2.20219 4.06192 2.43743 +330 1 4.31458 2.52073 5.06335 -0.0632538 1.3392 1.20942 +331 1 4.33916 1.68863 5.97126 -3.41941 3.44417 2.01134 +332 1 3.42212 2.64548 5.89276 -0.0280586 -2.67425 3.44656 +333 1 5.16333 1.72803 5.18363 0.62931 0.268233 -3.53629 +334 1 5.97493 2.53755 5.18126 5.42417 -2.99996 -10.5798 +335 1 5.97644 1.77632 6.05208 2.30795 -0.932212 -2.38345 +336 1 5.20771 2.64035 5.9206 -9.19429 -1.91265 5.67918 +337 1 6.82113 1.7288 5.07227 0.319047 -2.27809 2.42075 +338 1 7.76584 2.66005 5.04767 0.36372 -2.98667 3.98468 +339 1 7.68048 1.73285 5.98682 1.83082 2.55026 -3.35109 +340 1 6.77723 2.66049 6.0628 11.9195 -28.0419 -0.192401 +341 1 8.52926 3.48894 5.20725 0.756027 -4.20422 -2.12394 +342 1 0.880496 4.18659 5.21886 -2.21024 5.88812 -5.98946 +343 1 0.823278 3.46696 6.03218 3.03891 -2.5906 1.31712 +344 1 8.45604 4.28238 5.97679 3.43734 -0.298701 2.3281 +345 1 1.66848 3.43018 5.1681 4.45896 -2.65722 -0.776378 +346 1 2.47623 4.29797 5.21376 10.0204 -9.1421 -8.64412 +347 1 2.46945 3.49538 6.0664 15.3766 -12.245 -4.5397 +348 1 1.75883 4.22715 6.00615 -17.7933 12.7993 4.23364 +349 1 3.32535 3.48763 5.18919 1.16348 3.11251 -2.54898 +350 1 4.29953 4.30461 5.21296 -7.48003 6.57243 -13.8987 +351 1 4.32836 3.50006 5.90127 -9.25916 -18.9556 4.88449 +352 1 3.45987 4.23872 6.06433 -4.26661 1.09432 -3.11516 +353 1 5.16317 3.46797 5.05136 -2.20358 -10.3645 8.38524 +354 1 6.01128 4.18674 5.11415 3.72823 2.851 1.21774 +355 1 6.05124 3.32995 5.89897 -17.0823 24.7049 3.10753 +356 1 5.05098 4.23901 5.94533 18.4684 10.5132 6.34816 +357 1 6.93195 3.37363 5.21832 -12.1973 3.61502 -16.8233 +358 1 7.67472 4.24466 5.1448 -0.046387 1.44369 -2.14451 +359 1 7.59877 3.3598 5.99617 16.3705 11.4653 3.48987 +360 1 6.9163 4.33093 6.01136 -0.884888 -0.827495 0.436994 +361 1 8.47485 5.1618 5.06757 4.58611 -6.95556 3.64111 +362 1 0.866551 5.92561 5.22826 -2.4458 0.731452 -4.83922 +363 1 0.856029 5.03088 5.93872 -0.961264 1.16585 2.50638 +364 1 0.025531 6.08363 6.03301 -0.603503 -3.86392 0.433571 +365 1 1.73882 5.05771 5.16436 -7.87894 6.49017 -0.085231 +366 1 2.54586 5.89415 5.04217 4.79689 21.4637 24.3945 +367 1 2.63875 5.11717 5.9033 -10.4096 0.222879 12.4433 +368 1 1.7282 6.02787 5.89482 3.82714 -3.17245 6.07309 +369 1 3.41343 5.11888 5.19776 7.89672 -3.25441 -9.4893 +370 1 4.34849 6.08405 5.13729 -6.43313 -7.37614 1.57014 +371 1 4.30919 5.18003 6.06007 -0.523489 -1.53897 -0.492658 +372 1 3.32135 5.97978 5.88753 6.80953 0.93257 3.29984 +373 1 5.2281 5.04347 5.09516 -5.81719 1.07839 6.76004 +374 1 5.94602 5.8851 5.09539 3.02249 4.44225 2.10278 +375 1 6.04092 5.17575 6.07061 0.50428 -9.39491 -12.3653 +376 1 5.21437 6.06631 6.06016 -6.35945 -8.11006 -13.4627 +377 1 6.91579 5.12007 5.08308 -5.11836 -4.49572 6.409 +378 1 7.70983 5.91053 5.07808 1.5309 9.32926 6.58643 +379 1 7.76683 5.15653 6.01534 -1.66429 -5.18049 -8.59085 +380 1 6.93784 6.03915 5.96221 -25.2768 -19.3137 -6.75792 +381 1 0.0625638 6.74931 5.10819 -0.676634 2.54846 -0.0250987 +382 1 0.86361 7.61298 5.03345 -2.5044 7.0388 6.38474 +383 1 0.851706 6.88156 6.03092 0.201379 -3.97494 -1.33706 +384 1 0.0506067 7.6425 5.89338 -1.769 2.22377 0.622415 +385 1 1.66322 6.86583 5.19561 3.09287 -3.33398 -7.05581 +386 1 2.62799 7.62451 5.17609 -27.9662 28.0267 -4.59006 +387 1 2.66202 6.83135 5.96842 -24.8289 -0.817724 19.495 +388 1 1.64735 7.66733 5.92394 4.49398 5.54382 1.70924 +389 1 3.32274 6.93842 5.22499 45.6897 -26.2601 -20.0997 +390 1 4.28266 7.68312 5.1494 -0.162983 0.307259 3.3477 +391 1 4.21122 6.74188 6.04596 -0.795282 5.66715 -3.63702 +392 1 3.40786 7.67271 6.05784 2.18013 1.35082 -0.335047 +393 1 5.13386 6.80127 5.05013 6.80473 4.27889 3.23937 +394 1 6.0188 7.62146 5.18796 -3.27693 10.2601 -11.1928 +395 1 5.9142 6.93974 5.96821 7.16288 -22.7812 5.828 +396 1 5.1207 7.60724 5.96887 -13.0365 8.36981 -2.80723 +397 1 6.90344 6.91817 5.14994 -0.204819 -5.34708 -0.858742 +398 1 7.6747 7.73724 5.15589 4.74286 -4.17129 0.509029 +399 1 7.64232 6.7419 6.03772 18.4896 23.5989 -0.89996 +400 1 6.75496 7.62762 6.01659 7.03025 5.11039 1.24431 +401 1 0.0963896 0.0201086 6.80553 -1.40648 -0.449972 0.0493894 +402 1 0.835843 0.891839 6.79877 7.20248 -7.32555 0.745706 +403 1 0.918901 8.53581 7.64787 -17.0565 2.54879 17.4592 +404 1 0.0577403 0.896342 7.73471 1.30728 -4.31515 -1.61795 +405 1 1.61051 8.45024 6.92242 29.7484 14.9171 -14.6755 +406 1 2.47578 0.885204 6.88627 1.39053 -1.86497 -2.40181 +407 1 2.50444 0.0274811 7.76899 5.04636 2.83552 -7.66004 +408 1 1.76075 0.832954 7.77629 -9.26653 -0.311946 -7.26081 +409 1 3.50837 8.51457 6.78791 -7.98313 -6.7176 0.868776 +410 1 4.17648 0.757665 6.93195 8.57719 11.9693 -2.56623 +411 1 4.23832 0.0657272 7.77237 -2.00114 -7.83956 -8.62893 +412 1 3.37339 0.86481 7.76894 -4.57993 4.49098 -10.8865 +413 1 5.14407 0.0592801 6.76072 -1.57797 -1.16589 1.03837 +414 1 5.93853 0.879814 6.88423 6.63031 -4.29327 -1.40131 +415 1 6.03919 8.48714 7.63222 -2.96915 1.1039 1.2166 +416 1 5.15255 0.794385 7.73799 -0.425319 2.1861 -1.28188 +417 1 6.89313 0.0918814 6.89086 -1.49841 -3.77335 -3.98868 +418 1 7.61212 0.939213 6.80354 8.77263 -4.1407 2.30253 +419 1 7.70899 8.53849 7.72172 -1.01623 -1.03696 -1.75272 +420 1 6.83169 0.853131 7.69229 0.514071 1.96118 2.47006 +421 1 0.0995377 1.63996 6.92907 -20.9698 6.48021 -16.3567 +422 1 0.856061 2.59196 6.8009 3.6314 -4.45866 -1.95318 +423 1 0.7986 1.79168 7.64825 21.262 -5.45904 12.6361 +424 1 0.086833 2.5674 7.63497 -11.6486 2.30739 1.5806 +425 1 1.65946 1.72494 6.90853 -2.96091 -3.71884 -7.8878 +426 1 2.55175 2.62076 6.77199 1.34599 -1.3093 4.14575 +427 1 2.49264 1.73911 7.61263 5.68035 -0.198489 5.50404 +428 1 1.73023 2.55227 7.60126 -2.61513 6.16936 5.4644 +429 1 3.34887 1.7831 6.78557 0.7181 -0.718938 0.35045 +430 1 4.23104 2.60662 6.78869 6.67274 -5.2978 -0.800832 +431 1 4.35855 1.74494 7.60411 -4.34125 -3.35913 2.62052 +432 1 3.36542 2.60589 7.78048 1.27821 -1.57097 -4.57229 +433 1 5.20004 1.65594 6.83168 -6.03666 5.50106 2.07188 +434 1 5.95504 2.56783 6.93549 0.704503 2.20695 -11.5481 +435 1 6.05448 1.73837 7.6627 -1.83376 -2.83098 2.15288 +436 1 5.1146 2.5438 7.6124 2.3372 -0.290906 4.36925 +437 1 6.88113 1.721 6.77631 -7.16431 5.43568 2.84999 +438 1 7.667 2.62761 6.74793 2.83097 -7.51196 9.4855 +439 1 7.73348 1.72515 7.754 -4.1563 0.657477 -6.03723 +440 1 6.7624 2.63316 7.64937 6.65302 -0.565372 4.94425 +441 1 0.0849859 3.37793 6.84942 -10.0386 4.11872 -3.53604 +442 1 0.857904 4.2895 6.93068 1.24699 0.504054 -2.41984 +443 1 0.822866 3.35005 7.62376 7.62204 5.76535 8.89189 +444 1 0.0609986 4.27823 7.72873 -1.62474 0.278416 -2.41968 +445 1 1.65771 3.45598 6.89789 2.67743 0.0202624 -2.34558 +446 1 2.54508 4.23374 6.86348 0.989961 3.94158 3.39783 +447 1 2.51344 3.50821 7.77131 2.79285 -8.19104 -6.06353 +448 1 1.76675 4.31871 7.74484 -7.62178 -3.47349 -5.94274 +449 1 3.46999 3.3444 6.87805 -6.49672 7.19856 -0.129806 +450 1 4.27761 4.20284 6.7963 2.00695 2.57497 4.55692 +451 1 4.36643 3.33193 7.71738 -5.18938 3.59254 -0.980407 +452 1 3.39117 4.21736 7.78484 2.56803 1.85612 -2.81745 +453 1 5.17851 3.50703 6.80054 -0.562057 -4.69817 1.35476 +454 1 5.91855 4.34694 6.82856 20.1656 -16.4219 -1.68121 +455 1 5.94421 3.41917 7.73472 -0.686701 1.44481 -0.413888 +456 1 5.21752 4.35256 7.70192 -2.57704 -7.73472 4.05334 +457 1 6.81349 3.41173 6.82265 -1.40277 6.3135 5.01717 +458 1 7.75813 4.35693 6.90395 -1.64702 -1.61669 -0.476323 +459 1 7.7614 3.35066 7.72289 -1.59004 1.58238 -2.0122 +460 1 6.90386 4.19648 7.73719 0.143217 3.47184 -3.3084 +461 1 8.51568 5.21538 6.91302 4.27065 -2.85002 -1.50895 +462 1 0.951652 6.01174 6.9207 -11.7991 -7.13131 -18.8927 +463 1 0.936182 5.16144 7.77632 -7.30596 -5.41004 -9.74737 +464 1 0.00163562 6.07485 7.63199 0.624183 -4.07361 5.99132 +465 1 1.66533 5.15284 6.74597 2.96466 -1.56742 2.06772 +466 1 2.61909 5.93515 6.89385 -1.40662 1.18192 -1.24787 +467 1 2.46927 5.13962 7.72554 6.76967 2.2802 -3.81441 +468 1 1.64453 6.02831 7.68681 19.7677 -7.24739 11.5441 +469 1 3.40343 5.06011 6.8889 -0.198511 0.401262 -0.796323 +470 1 4.30752 6.01937 6.85588 -10.789 -11.9311 3.49788 +471 1 4.28416 5.14222 7.62835 0.609452 -0.263512 0.8346 +472 1 3.47645 6.07368 7.70428 -7.22384 -10.7657 -0.906726 +473 1 5.22078 5.0656 6.90915 -18.0053 20.6161 -6.39 +474 1 5.99499 5.93089 6.77083 3.48021 13.0571 15.6598 +475 1 6.05342 5.21794 7.69617 -5.52282 -4.0969 2.40523 +476 1 5.15908 5.93838 7.59985 0.288818 1.34614 5.01043 +477 1 6.82844 5.21514 6.92244 2.6589 -10.3439 -6.80084 +478 1 7.65444 5.90306 6.73997 5.39846 9.09532 17.1635 +479 1 7.73871 5.1328 7.74827 -11.0217 0.411956 -11.9718 +480 1 6.85057 5.9849 7.66627 -2.19779 2.18231 4.19621 +481 1 8.49223 6.85953 6.88515 0.63092 3.61848 -3.8326 +482 1 0.912061 7.72558 6.80554 -14.7372 -15.0451 -0.530208 +483 1 0.94972 6.80465 7.60047 -8.86666 17.9559 7.11774 +484 1 0.0485157 7.69847 7.76952 0.871021 -3.29928 -3.01128 +485 1 1.7395 6.92207 6.74618 -0.216972 -4.99493 2.92958 +486 1 2.48517 7.73307 6.85664 4.02861 0.442708 -0.186237 +487 1 2.60224 6.86957 7.70226 -2.68029 -0.280597 -1.3011 +488 1 1.75659 7.71058 7.78997 -12.217 -12.015 -24.8657 +489 1 3.36601 6.81921 6.83807 2.83617 1.11452 1.50668 +490 1 4.30578 7.6333 6.9198 -11.3388 0.787746 -11.6868 +491 1 4.17656 6.84912 7.75346 9.62737 7.65922 -1.79281 +492 1 3.37828 7.72239 7.62462 0.544776 0.263736 1.68806 +493 1 5.03666 6.75188 6.83201 10.5371 18.8221 7.02157 +494 1 5.88561 7.69892 6.74579 2.44744 2.75196 7.83 +495 1 6.02886 6.89217 7.71335 -1.94107 -2.07696 0.28038 +496 1 5.05253 7.6432 7.63466 10.7152 0.484071 10.517 +497 1 6.76592 6.82276 6.85512 1.71624 -1.12004 -2.46021 +498 1 7.63682 7.73046 6.77254 1.37903 -1.27982 -0.239663 +499 1 7.60482 6.74157 7.76697 8.04118 12.5638 -12.9988 +500 1 6.86424 7.69163 7.60229 0.0588858 0.119654 2.66424 +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +500 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 8.2207069144348992e+00 +0.0000000000000000e+00 8.2207069144348992e+00 +0.0000000000000000e+00 8.2207069144348992e+00 +ITEM: ATOMS id type x y z f_1[1] f_1[2] f_1[3] +1 1 0.0109462 8.19276 8.15872 -2.39444 9.6729 7.55614 +2 1 0.913757 0.79291 0.0997863 -14.8553 6.06953 -19.2131 +3 1 0.922041 0.00329478 0.797424 -4.57303 -13.0314 3.29774 +4 1 0.0667547 0.768895 0.898382 -4.60646 8.57627 -8.38591 +5 1 1.74036 8.13245 0.0766359 -17.8989 17.5469 -5.09772 +6 1 2.47269 0.889925 0.0248853 -5.42566 -21.0007 -17.6291 +7 1 2.46322 8.1233 0.872599 4.75898 11.1097 -4.77186 +8 1 1.65846 0.837491 0.791152 15.1363 -5.40511 14.9864 +9 1 3.32881 8.19546 0.053156 -13.3342 -9.93994 -9.94684 +10 1 4.03279 0.760382 0.00184897 9.91793 7.67217 -5.53917 +11 1 4.13378 8.169 0.732239 -0.574085 -2.22965 11.4349 +12 1 3.20922 0.774467 0.746193 11.6707 -5.4973 20.7036 +13 1 4.84922 8.194 8.14339 7.30804 6.79019 8.16024 +14 1 5.8218 0.772541 8.17358 -10.0231 -1.2549 7.34514 +15 1 5.68256 8.16785 0.77714 3.02512 1.45358 -0.272422 +16 1 4.85759 0.84201 0.746179 4.61671 -0.701957 -1.77598 +17 1 6.62546 8.16087 8.21828 -7.1959 6.90651 13.7327 +18 1 7.47259 0.88807 0.0569708 -4.40901 -2.93179 -3.05075 +19 1 7.47431 0.0411346 0.771198 -11.1102 -3.58532 -4.76152 +20 1 6.57656 0.847149 0.913044 26.339 -17.4997 -36.7448 +21 1 8.18759 1.70398 8.18761 4.1072 -0.492398 0.811998 +22 1 0.899666 2.41042 8.17073 -11.5274 -4.75425 3.68191 +23 1 0.850302 1.72005 0.839978 5.34352 -14.6759 -1.78579 +24 1 0.0603398 2.39798 0.844681 -8.60658 17.5352 -6.64359 +25 1 1.71223 1.59237 0.0242378 -11.0164 14.7761 -6.28233 +26 1 2.39934 2.5183 0.00540478 8.02997 -3.83137 6.03634 +27 1 2.48112 1.56604 0.834626 2.61805 16.1266 0.364368 +28 1 1.6143 2.50502 0.831093 22.9512 -23.9291 -18.4162 +29 1 3.30714 1.5456 0.0352888 3.02185 20.9324 -4.02492 +30 1 4.17998 2.44319 8.21567 -15.5858 -1.30182 -5.2994 +31 1 4.13571 1.72982 0.900024 -11.4398 -17.9409 -9.12775 +32 1 3.31093 2.54257 0.820203 -10.3368 -11.5392 -3.6507 +33 1 5.0044 1.71067 8.16991 -2.52586 -20.2729 12.2321 +34 1 5.83707 2.42978 0.0552544 -9.07217 4.33101 -1.43054 +35 1 5.68958 1.61323 0.87339 20.6627 3.79367 -24.2404 +36 1 4.88712 2.41203 0.783075 18.227 14.4306 8.63131 +37 1 6.51234 1.55641 0.0925838 9.00513 9.77167 -3.15357 +38 1 7.38894 2.55021 8.21638 -3.89162 -5.39246 1.97695 +39 1 7.3932 1.68143 0.910549 14.6159 -16.4356 -32.9418 +40 1 6.52029 2.5195 0.875176 1.21021 -6.27577 -1.18313 +41 1 0.0178952 3.25358 8.17469 3.31384 23.2108 27.1434 +42 1 0.75874 4.10726 8.14569 6.02202 2.9315 8.91628 +43 1 0.895393 3.22207 0.752637 -27.1078 14.1691 0.641871 +44 1 8.18599 4.06691 0.900855 -0.259841 0.495686 -5.35481 +45 1 1.55285 3.22874 8.15747 6.98433 26.3863 8.64396 +46 1 2.49624 4.20319 8.19485 -11.6121 -5.75058 -7.87094 +47 1 2.42547 3.30302 0.888339 10.6882 -12.4594 -2.99107 +48 1 1.6862 4.0108 0.835279 -13.347 15.0654 -7.27246 +49 1 3.22 3.33904 0.0153378 4.70565 -17.4148 -11.2872 +50 1 4.15099 4.01359 0.0472035 -3.25232 -0.128895 -8.82814 +51 1 4.06799 3.24916 0.843927 9.3476 8.05351 2.04714 +52 1 3.19501 4.05 0.736238 12.2088 14.8797 22.981 +53 1 4.93359 3.21205 8.21538 5.02686 8.32666 2.39487 +54 1 5.81852 4.10681 0.0313505 -9.96067 16.6194 -8.35941 +55 1 5.78406 3.36669 0.776887 -2.74739 -9.47942 10.9149 +56 1 4.90983 4.0411 0.864362 0.837356 4.14382 -0.368312 +57 1 6.53897 3.36302 8.19911 9.90234 -20.173 11.5285 +58 1 7.46276 4.04697 0.0534703 -5.76424 1.73449 -3.50806 +59 1 7.34501 3.24442 0.827453 2.34892 5.8087 4.09531 +60 1 6.59021 4.15121 0.905225 -2.44603 -12.1461 -5.89568 +61 1 8.13258 4.93013 0.0905402 6.61239 1.0085 -5.83678 +62 1 0.918786 5.84938 8.18896 -100.34 -125.435 4.75603 +63 1 0.733666 4.90689 0.894865 5.0782 -1.1493 -19.9038 +64 1 8.13743 5.78012 0.885656 21.4143 -27.2006 -30.8387 +65 1 1.67225 4.91657 0.0765019 -6.36422 -5.41993 -9.68754 +66 1 2.43163 5.74665 8.16344 0.0454169 7.36314 0.282499 +67 1 2.52248 4.94902 0.779546 -17.0632 -3.92502 5.40756 +68 1 1.68817 5.73221 0.738326 -10.7061 -22.6586 25.0306 +69 1 3.20519 4.98792 8.20267 13.0471 -20.6699 18.764 +70 1 4.1645 5.8475 0.0144516 -41.0284 -51.2746 -22.2701 +71 1 4.12065 4.85332 0.726813 -6.7392 5.54296 9.04283 +72 1 3.22358 5.72978 0.902951 13.2902 6.38408 -11.6219 +73 1 4.86923 4.9681 8.18768 10.2044 -1.77915 -2.81852 +74 1 5.77301 5.70687 8.13281 -22.5863 16.9623 33.7246 +75 1 5.78731 4.97674 0.770243 -6.25016 -2.29075 -2.78772 +76 1 4.89256 5.78932 0.733037 29.9716 -43.8231 39.093 +77 1 6.61696 5.02048 8.19969 -11.3595 -28.891 -1.36328 +78 1 7.33645 5.74186 0.0277988 27.1444 12.1113 -11.7126 +79 1 7.32557 4.92161 0.798933 6.38759 1.63603 8.88722 +80 1 6.60198 5.76847 0.724174 -12.087 6.06842 22.1567 +81 1 0.0632305 6.4911 0.00261304 -6.53376 9.85675 7.22968 +82 1 0.730752 7.3973 8.19101 19.8665 -4.89129 14.6872 +83 1 0.894205 6.53954 0.906348 -15.672 -5.70878 -18.8817 +84 1 0.0916376 7.35116 0.914882 -39.3163 -12.8553 -54.9509 +85 1 1.54844 6.4779 0.0899714 109.204 121.919 -0.90408 +86 1 2.45374 7.43343 8.1677 17.1682 -16.9212 2.53497 +87 1 2.38485 6.48495 0.871503 16.8711 24.0952 -19.5071 +88 1 1.73482 7.30198 0.918245 -4.50526 25.4363 -21.6583 +89 1 3.35837 6.52948 0.00621289 -17.9347 4.05163 8.57797 +90 1 4.15544 7.30314 8.17418 -3.86421 14.3399 10.028 +91 1 4.18078 6.49797 0.807337 -33.0181 25.5019 29.3461 +92 1 3.28881 7.33369 0.840128 0.0678552 -0.60668 -1.16807 +93 1 4.86711 6.50097 0.0644243 55.2704 56.5162 -42.5456 +94 1 5.6807 7.37537 8.15497 2.37339 1.6253 6.06405 +95 1 5.83906 6.54647 0.813774 -8.31017 -0.439493 -0.862375 +96 1 4.90102 7.33548 0.785855 3.38301 3.17369 4.3776 +97 1 6.62594 6.60016 8.16507 -28.5529 -10.5165 29.461 +98 1 7.41236 7.32596 8.18119 12.8158 16.6867 22.5272 +99 1 7.48788 6.57526 0.906715 -17.6408 15.7915 -12.9219 +100 1 6.60846 7.32088 0.891813 -2.23221 1.45701 -6.99196 +101 1 8.17 8.13088 1.54543 21.7946 28.0076 23.7334 +102 1 0.889634 0.755106 1.5647 -2.22366 9.82139 12.4406 +103 1 0.787312 0.00367743 2.47285 9.7959 7.14049 -7.07183 +104 1 0.0399172 0.910289 2.54829 -10.4426 -54.7685 -48.8923 +105 1 1.70161 0.076186 1.70291 0.655659 -5.9987 -1.53887 +106 1 2.5425 0.840944 1.65312 -5.39214 -2.71573 1.42057 +107 1 2.39333 0.0846015 2.56412 19.1459 -13.6703 -26.8796 +108 1 1.62991 0.895915 2.55976 -9.37186 -8.23605 -42.2796 +109 1 3.3255 0.037006 1.60354 -4.30714 4.73223 -3.06839 +110 1 4.20236 0.841896 1.65063 -10.9567 4.39501 -2.76043 +111 1 4.12511 8.16508 2.38147 6.48597 31.2032 29.2026 +112 1 3.37125 0.822661 2.38548 -3.89508 0.169143 6.57094 +113 1 4.86677 0.028066 1.55007 9.3902 -7.55136 2.71818 +114 1 5.8528 0.805894 1.56988 -29.5994 -6.3857 29.2326 +115 1 5.73944 8.2048 2.38025 -0.334985 15.3443 16.2286 +116 1 4.92058 0.739392 2.48512 1.8123 5.57771 -0.399822 +117 1 6.61747 8.14877 1.63757 -7.92973 14.3058 -0.0863647 +118 1 7.37923 0.805843 1.70616 17.0436 -4.06349 -13.2175 +119 1 7.38533 8.17909 2.55221 2.10247 4.05286 -21.3656 +120 1 6.66981 0.91359 2.42776 -18.0385 -1.7859 9.16667 +121 1 8.21433 1.71804 1.64878 9.58557 -8.70073 -6.06848 +122 1 0.91795 2.50647 1.62107 -49.2165 -42.2319 12.3144 +123 1 0.778719 1.62612 2.3667 15.8366 8.16624 0.723179 +124 1 0.0388825 2.56454 2.43408 -0.65123 -11.9302 4.78295 +125 1 1.70614 1.64161 1.56714 -4.83448 1.54656 8.88708 +126 1 2.55772 2.51525 1.68348 -33.0305 -26.0768 -4.05159 +127 1 2.46774 1.68666 2.4295 -0.728639 -2.90689 1.14987 +128 1 1.58495 2.48207 2.53043 32.1395 -14.2129 -42.8967 +129 1 3.28639 1.69638 1.58862 0.141668 -5.07807 4.69228 +130 1 4.07581 2.46356 1.66204 5.75617 5.24573 6.028 +131 1 4.09064 1.65395 2.45941 5.06207 -1.15698 -3.64398 +132 1 3.2978 2.42597 2.51229 -0.392826 8.06961 -8.70923 +133 1 4.99952 1.60143 1.58928 -25.5713 -7.8385 22.8567 +134 1 5.66634 2.3835 1.71386 21.3679 17.6667 -19.1597 +135 1 5.74656 1.70527 2.50917 3.11288 -14.4009 7.07914 +136 1 4.97163 2.46224 2.45828 -14.3686 2.77193 11.4917 +137 1 6.62989 1.62285 1.56611 -20.0211 14.8617 27.1541 +138 1 7.37036 2.42163 1.58976 1.23932 26.194 15.084 +139 1 7.49234 1.71782 2.38524 -11.5645 -3.14792 16.0927 +140 1 6.57493 2.44646 2.50738 3.76278 -0.484364 -1.65815 +141 1 8.13855 3.28395 1.66364 9.95915 -4.6352 -13.1677 +142 1 0.822632 4.13968 1.61013 -1.66869 -18.1546 6.90643 +143 1 0.836195 3.27368 2.50106 -4.0013 3.27813 -2.23185 +144 1 0.00706469 4.04664 2.42415 6.78153 4.66429 11.0832 +145 1 1.56864 3.19926 1.57501 43.2252 54.2341 22.2486 +146 1 2.37435 4.19613 1.65007 19.5365 -23.6872 -5.11708 +147 1 2.53204 3.33272 2.45976 -10.1616 -1.37273 8.96239 +148 1 1.5958 4.02298 2.45513 4.44558 4.83545 -0.957126 +149 1 3.24862 3.20562 1.71329 33.7169 30.1535 -8.86948 +150 1 4.04966 4.11271 1.69147 14.455 0.133261 -16.0308 +151 1 4.17313 3.29199 2.42566 -5.80506 -5.3643 5.35172 +152 1 3.37886 4.04594 2.4591 -12.864 4.86539 14.8631 +153 1 5.00029 3.3715 1.7428 -16.124 -51.6521 -51.6846 +154 1 5.71525 4.10565 1.71106 18.126 11.5713 -25.6554 +155 1 5.67368 3.37853 2.52254 40.5036 -38.7002 16.4445 +156 1 4.98188 4.047 2.42098 -44.4942 70.6847 47.3189 +157 1 6.52567 3.216 1.71371 -0.385424 4.96723 -0.762826 +158 1 7.40007 4.08176 1.73877 -6.32286 -1.56827 -20.7524 +159 1 7.42837 3.30042 2.4503 -10.1629 -6.83382 9.16894 +160 1 6.52178 4.09551 2.40152 8.21405 -5.0269 3.15343 +161 1 0.00699263 4.85762 1.69229 -17.0824 5.05692 -6.94595 +162 1 0.756152 5.6631 1.60232 14.3979 15.6472 -4.59775 +163 1 0.764682 4.99903 2.39299 18.2885 -21.5851 21.4239 +164 1 0.0800264 5.75765 2.41619 -22.1201 11.2764 3.26076 +165 1 1.60226 4.84293 1.69094 -9.96687 23.2298 -5.36928 +166 1 2.38001 5.77059 1.56073 -4.13582 -26.0328 27.2432 +167 1 2.39304 4.87599 2.45449 3.86796 9.40324 7.0282 +168 1 1.5595 5.8443 2.45554 15.3251 -19.3503 -10.1983 +169 1 3.24805 4.8639 1.55208 5.72697 0.833939 9.91621 +170 1 4.12523 5.83768 1.72183 2.66681 -7.18069 -9.93584 +171 1 4.14719 4.98927 2.48442 -5.36599 -4.29088 6.08995 +172 1 3.29103 5.75037 2.41213 -9.14312 -21.8308 11.1485 +173 1 4.88531 4.96658 1.71552 5.62499 -3.03462 -8.19539 +174 1 5.80164 5.66001 1.66617 -22.0309 23.7646 0.752493 +175 1 5.79599 4.88622 2.4436 -18.3543 9.31939 -6.6266 +176 1 4.94007 5.78406 2.4889 7.47518 -6.1933 -6.95152 +177 1 6.50282 4.96059 1.57437 23.9581 -12.4339 8.07292 +178 1 7.43162 5.77666 1.60532 -16.9632 -9.02864 21.2089 +179 1 7.30902 4.88901 2.38072 1.39073 12.4251 10.603 +180 1 6.52191 5.81931 2.5443 7.19321 -57.902 -45.2674 +181 1 0.0825324 6.49799 1.58172 -0.0568703 17.3702 26.5223 +182 1 0.807327 7.40344 1.54436 38.413 9.53604 44.8678 +183 1 0.85313 6.5885 2.46372 -17.206 13.7674 -10.0743 +184 1 0.0766958 7.42441 2.49843 -14.0409 -5.69227 -10.6889 +185 1 1.56626 6.64679 1.65111 17.2201 -21.881 29.7832 +186 1 2.51758 7.48828 1.7101 -1.12703 -9.37355 7.34939 +187 1 2.48642 6.48139 2.37761 -17.45 9.10758 18.4987 +188 1 1.62607 7.39059 2.4668 5.47881 2.11068 -4.08662 +189 1 3.22096 6.48273 1.68127 15.0894 18.1205 -19.6751 +190 1 4.01435 7.47003 1.70259 9.92584 -36.0532 -31.9009 +191 1 4.01053 6.48307 2.56537 4.58494 43.5966 -38.8488 +192 1 3.31708 7.46346 2.49246 -11.1632 -6.704 4.9273 +193 1 4.97912 6.56412 1.70872 -0.0323444 1.40088 -5.51009 +194 1 5.76314 7.42951 1.73429 -4.71194 -18.4847 -18.3917 +195 1 5.75053 6.57569 2.52583 -15.5416 2.95473 -19.9489 +196 1 4.86788 7.33538 2.51839 21.348 1.25465 -21.9702 +197 1 6.54919 6.48383 1.72129 1.36669 8.74928 -8.3147 +198 1 7.40692 7.48075 1.59274 -4.17636 -24.5364 8.08039 +199 1 7.31105 6.49008 2.55841 18.9084 8.98379 -5.81349 +200 1 6.56124 7.4093 2.46898 3.88266 -3.866 3.64736 +201 1 0.0467578 0.0587236 3.25639 -2.58837 -3.06001 8.14477 +202 1 0.919472 0.840587 3.2901 -13.7955 -3.94396 11.0802 +203 1 0.913851 8.17129 4.10222 -17.0314 2.36091 -15.061 +204 1 8.12452 0.831674 4.11824 2.96137 1.66258 0.705395 +205 1 1.72266 8.12268 3.2983 -16.5809 -0.000561518 15.0322 +206 1 2.36681 0.848699 3.23189 33.3023 -3.20785 26.2082 +207 1 2.52451 0.093755 4.0501 -20.4816 -4.23237 16.7496 +208 1 1.57332 0.89934 4.17862 1.65408 -10.4059 -4.79402 +209 1 3.23411 8.18086 3.33998 20.9401 7.85353 -15.8307 +210 1 4.12777 0.912462 3.28751 -3.54395 -8.15241 -0.704223 +211 1 4.05479 8.16789 4.17086 6.43266 7.42359 -18.6916 +212 1 3.3412 0.763098 4.14988 -8.17365 16.5822 -19.2151 +213 1 4.85923 8.19378 3.30398 3.75427 6.29815 -1.39384 +214 1 5.723 0.836221 3.31262 4.07436 -7.7371 -12.3645 +215 1 5.78765 0.0695661 4.10746 2.41957 -4.40965 -1.14115 +216 1 4.97909 0.892899 4.12401 -13.5931 -16.8127 1.66952 +217 1 6.57108 0.0657357 3.30807 -10.4223 -10.045 -0.47006 +218 1 7.35373 0.738008 3.24493 15.9915 16.7978 9.43624 +219 1 7.34677 0.0332152 4.15763 12.3358 5.5849 -5.20193 +220 1 6.67147 0.918341 4.12524 -9.23951 -11.4667 0.577623 +221 1 0.0788919 1.58016 3.21314 -1.55258 49.5779 50.5391 +222 1 0.904188 2.40885 3.22233 -31.0956 -2.82504 30.7646 +223 1 0.877149 1.74225 4.15165 7.55452 -10.7555 -4.03202 +224 1 0.0936835 2.40444 4.16194 -19.0736 7.56858 -3.47745 +225 1 1.71236 1.61805 3.29179 -19.7602 28.7111 2.45155 +226 1 2.5486 2.41776 3.31547 -43.6679 25.9149 -16.2942 +227 1 2.39734 1.55251 4.06577 15.8032 7.53109 12.4652 +228 1 1.72237 2.5181 4.15876 -10.7679 -10.2774 -3.05137 +229 1 3.23039 1.71099 3.29502 25.8646 -44.0791 -9.55739 +230 1 4.12827 2.45813 3.1934 -6.48806 -10.3202 8.62038 +231 1 4.19407 1.63495 4.09603 -15.4993 6.39445 10.1662 +232 1 3.20761 2.36838 4.07177 19.5744 11.0493 29.9438 +233 1 4.94979 1.63514 3.37535 1.21152 5.67416 -27.5114 +234 1 5.82776 2.47766 3.34313 -3.66364 1.42568 -1.20833 +235 1 5.76542 1.58538 4.03513 14.4098 19.4192 12.2978 +236 1 4.95489 2.43394 4.07273 -1.13246 5.06376 7.36624 +237 1 6.661 1.60077 3.30919 -3.43354 8.94885 -5.94598 +238 1 7.49515 2.56092 3.28033 -10.5336 -12.2625 1.51454 +239 1 7.39275 1.71767 4.16117 3.5537 3.96098 0.811537 +240 1 6.54244 2.56469 4.20941 11.0399 -32.6669 -26.4629 +241 1 8.2116 3.30444 3.37137 5.74747 4.63382 -14.2394 +242 1 0.840624 4.14226 3.27407 -5.48884 -5.61804 0.498093 +243 1 0.734437 3.23139 4.08576 22.8281 5.93798 4.2063 +244 1 0.0471721 4.13123 4.11158 -4.3827 3.27424 0.087671 +245 1 1.70286 3.20807 3.23042 -2.96775 14.0769 10.9943 +246 1 2.38769 4.13105 3.27446 4.88078 -2.82576 -1.60425 +247 1 2.4087 3.28686 4.02353 16.6104 0.201322 7.1777 +248 1 1.69983 4.0678 4.13415 -10.6977 3.91895 2.19645 +249 1 3.34377 3.23634 3.36851 -11.3528 1.51526 -17.2895 +250 1 4.2055 4.03294 3.37597 -23.3492 5.34016 -26.85 +251 1 4.03955 3.26203 4.11941 11.7033 -4.94552 16.1773 +252 1 3.21963 4.01243 4.16102 5.66091 6.82551 -5.40832 +253 1 4.83261 3.19517 3.32313 20.1816 8.52525 -2.26656 +254 1 5.77148 4.16495 3.28824 -31.489 -26.7787 -6.90732 +255 1 5.82425 3.30115 4.19401 -37.1473 -6.40083 -11.3511 +256 1 4.87724 4.09609 4.11549 36.2568 -10.3151 3.06059 +257 1 6.58329 3.33973 3.22197 0.0461967 -7.66729 -2.40242 +258 1 7.43644 4.05966 3.30265 -3.56999 5.92726 -1.37248 +259 1 7.48286 3.29775 4.19646 -3.89008 -9.4431 -11.0777 +260 1 6.47907 4.03353 4.01383 29.8324 22.3851 15.73 +261 1 8.15241 5.02846 3.31122 10.6595 -5.28085 -5.36552 +262 1 0.804631 5.8376 3.20576 13.4276 -32.1322 14.0647 +263 1 0.877129 4.8969 4.13251 -1.47043 5.42126 -0.0257482 +264 1 0.0651636 5.75976 4.1954 -9.31697 -6.72952 -15.907 +265 1 1.57617 4.92532 3.28718 5.51341 5.68743 -3.59864 +266 1 2.42583 5.72219 3.30114 4.35376 1.25963 -4.44713 +267 1 2.4551 4.89394 4.08913 0.180251 2.9051 2.6698 +268 1 1.67099 5.80732 4.08057 -5.18981 -1.73911 5.86888 +269 1 3.33413 4.84944 3.32334 -2.55875 1.02427 -1.99572 +270 1 4.20493 5.83452 3.24979 -21.4386 -63.3893 34.6056 +271 1 4.19181 4.8901 4.01924 -15.0952 14.1984 13.5631 +272 1 3.36551 5.83759 4.08786 -9.40985 -16.2604 3.57159 +273 1 4.9921 4.89151 3.36329 -7.1819 8.21085 -25.7306 +274 1 5.77026 5.74279 3.2372 -19.2661 -13.3988 15.8911 +275 1 5.68576 4.90444 4.10854 12.1482 9.27276 4.35592 +276 1 4.84395 5.80423 4.20869 23.9245 -11.025 -23.296 +277 1 6.4858 4.83859 3.18898 36.5327 24.7135 15.3623 +278 1 7.30315 5.68446 3.36881 -0.385614 18.5722 -20.0571 +279 1 7.37309 4.9455 4.05168 -2.3203 -17.2743 20.9328 +280 1 6.63896 5.83294 4.18727 -7.1922 -10.1498 -0.517575 +281 1 0.0942908 6.52233 3.3159 -35.7657 14.4096 -15.937 +282 1 0.836387 7.40457 3.20726 4.47284 -0.4112 17.4557 +283 1 0.739312 6.64758 4.08638 39.4722 -18.3951 12.5032 +284 1 8.21631 7.30153 4.06221 -15.2581 27.9702 -0.672668 +285 1 1.58758 6.54973 3.25882 10.9016 11.7867 8.01769 +286 1 2.56536 7.3619 3.34369 -76.1678 6.55793 -73.9603 +287 1 2.52556 6.61112 4.10224 -30.5256 -34.6487 7.0656 +288 1 1.62124 7.32393 4.18622 0.536802 -1.56833 -6.92191 +289 1 3.3681 6.64037 3.37818 -8.53205 -51.1792 -62.7851 +290 1 4.15298 7.36163 3.20593 -21.9528 4.612 22.3686 +291 1 4.12464 6.54108 4.035 14.4356 20.1369 22.2034 +292 1 3.19906 7.31073 4.01315 82.3215 73.9575 117.35 +293 1 4.9065 6.52075 3.26638 28.3768 26.425 6.32862 +294 1 5.74138 7.36096 3.25092 -0.970474 8.69807 4.03129 +295 1 5.81652 6.58456 4.03756 -14.737 -0.580193 0.741413 +296 1 4.87586 7.39212 4.03191 6.20313 -4.00572 5.92319 +297 1 6.48611 6.49412 3.21889 20.5434 47.1119 52.8917 +298 1 7.41876 7.4098 3.23912 -0.409624 -8.77258 11.2401 +299 1 7.35972 6.63444 4.07034 1.58562 -5.33459 -2.2315 +300 1 6.64271 7.48657 4.18074 -12.6903 -3.8877 -6.90745 +301 1 8.18545 0.00495327 4.98201 0.835961 10.4978 -8.83054 +302 1 0.830861 0.760813 4.98094 -9.95647 8.66756 -7.1447 +303 1 0.808969 0.00641337 5.74397 -4.48252 1.30502 4.67537 +304 1 0.018812 0.795135 5.84676 0.988121 0.902183 -11.1018 +305 1 1.60862 0.0119183 4.84308 17.0508 -2.91068 17.4808 +306 1 2.50239 0.876955 4.96833 -9.09304 -5.08176 -4.69214 +307 1 2.44832 8.14323 5.81234 6.77585 9.13889 -19.0494 +308 1 1.56911 0.731109 5.75394 17.4698 11.7404 -4.99849 +309 1 3.28793 0.0458368 4.91142 -7.08209 -9.95818 14.0315 +310 1 4.07208 0.823519 4.87126 26.6153 -9.6486 13.2451 +311 1 4.06672 0.0477209 5.80002 10.3282 0.566915 -15.466 +312 1 3.2042 0.88056 5.78404 3.8932 -8.75566 -1.61055 +313 1 5.02696 0.0222739 4.88991 -12.0715 4.27124 3.2294 +314 1 5.73734 0.886325 4.85298 9.71713 -6.59089 13.6933 +315 1 5.79543 0.0389128 5.76135 -3.4407 3.92019 -0.496418 +316 1 4.85161 0.780997 5.82861 2.47749 38.2945 -34.2513 +317 1 6.64858 0.0906911 4.97808 -13.982 -18.784 -13.0607 +318 1 7.30429 0.900733 5.00382 63.7384 -13.5798 -32.445 +319 1 7.4114 8.15633 5.76261 6.64498 1.40027 -2.33346 +320 1 6.66824 0.783026 5.72649 -29.5414 5.85716 47.7215 +321 1 0.0281683 1.66949 4.95949 -0.425666 -3.96058 2.91208 +322 1 0.893447 2.47998 4.9969 -1.93266 1.10148 -5.4469 +323 1 0.843715 1.6221 5.7589 -0.766033 4.56211 -3.21682 +324 1 0.0782454 2.53663 5.73256 -1.35265 -11.3593 -4.90859 +325 1 1.65079 1.66704 4.93767 -0.533365 0.139965 4.11876 +326 1 2.51601 2.38441 4.90805 0.649871 6.98133 -0.140965 +327 1 2.41175 1.72195 5.72474 2.84663 -8.86686 7.73621 +328 1 1.61538 2.54316 5.81674 -0.089029 -19.7728 -12.4678 +329 1 3.35891 1.54703 4.95536 -9.48818 22.4331 -2.56554 +330 1 4.08195 2.54313 5.01426 16.1748 -2.70068 -21.0768 +331 1 4.12034 1.74262 5.81366 10.5637 -13.2904 -3.74489 +332 1 3.37175 2.4672 5.72729 -31.5422 -3.32565 13.6818 +333 1 5.0033 1.68848 4.95948 -13.0392 -13.8401 -3.80319 +334 1 5.66589 2.47997 4.89515 25.4212 2.24436 -8.70857 +335 1 5.79028 1.55903 5.82666 2.05757 18.2253 -24.3713 +336 1 5.0311 2.46113 5.68951 -16.9377 1.04 21.5338 +337 1 6.57827 1.56896 5.01204 -21.5711 32.5342 -4.2816 +338 1 7.31623 2.52382 4.98258 18.6955 -8.52314 -2.25127 +339 1 7.45461 1.64332 5.76278 -16.0261 1.47893 -16.982 +340 1 6.64089 2.42957 5.78128 -11.0128 0.688597 0.00936653 +341 1 0.0932375 3.33117 4.94446 -5.57952 -6.38154 1.87127 +342 1 0.757472 4.19176 4.95128 10.4651 -6.09524 -1.36969 +343 1 0.907905 3.31127 5.7437 -27.4593 -10.6172 -1.55436 +344 1 0.042027 4.05791 5.75958 -12.212 5.31553 -4.25834 +345 1 1.73758 3.25237 5.02547 -7.72352 0.251809 -15.9993 +346 1 2.4871 4.0191 4.9543 -17.108 24.4302 2.09179 +347 1 2.45668 3.23081 5.78465 2.15315 9.79763 4.28788 +348 1 1.58106 4.05092 5.80356 25.1427 18.6418 -4.49313 +349 1 3.19249 3.31456 5.03239 24.0259 -22.2006 -10.8088 +350 1 4.20707 4.15779 4.866 -22.1265 -5.11578 15.6203 +351 1 4.10653 3.22389 5.85277 -11.4198 11.552 -29.8203 +352 1 3.32529 4.01575 5.8236 -9.29377 10.539 -6.33768 +353 1 5.02426 3.35158 5.01899 -31.0395 -2.45923 -24.1365 +354 1 5.68644 4.17189 4.85403 7.36649 -6.63658 10.5871 +355 1 5.74132 3.29275 5.69662 23.2126 4.63385 22.4488 +356 1 4.92531 4.19073 5.71088 -1.56015 -9.54037 12.8094 +357 1 6.54444 3.23385 4.93781 3.72392 28.1796 29.5331 +358 1 7.41233 4.02229 4.92924 -1.20364 12.0626 9.54412 +359 1 7.4663 3.28529 5.82942 -29.7597 -4.87929 -37.7444 +360 1 6.60644 4.05138 5.75927 -5.95188 5.2753 -7.63938 +361 1 8.20344 4.97671 5.0085 -9.77785 -27.0171 -16.098 +362 1 0.764125 5.65629 4.97235 19.2848 26.171 -13.514 +363 1 0.873777 4.9677 5.68286 -0.798932 -14.5746 27.2238 +364 1 8.1297 5.72693 5.67887 36.2224 14.0656 51.1647 +365 1 1.7318 5.02959 5.01529 -5.49043 -14.6131 -16.8314 +366 1 2.44542 5.85219 4.93063 19.3822 -11.3762 -19.1618 +367 1 2.55143 4.96012 5.6972 2.49476 -2.70049 4.14057 +368 1 1.7425 5.82205 5.68004 -17.6493 -28.263 45.9708 +369 1 3.3219 4.92271 4.83646 -0.36054 0.182371 1.57441 +370 1 4.15401 5.67616 4.9285 -21.3575 6.09757 11.4691 +371 1 4.07715 4.94174 5.74451 -0.595544 -7.12056 -1.40506 +372 1 3.31639 5.79418 5.70206 -6.4923 -7.4901 3.07645 +373 1 4.92581 4.94202 4.97984 -0.22012 5.90431 -14.5879 +374 1 5.73821 5.69855 4.88283 0.98112 8.81137 -0.251897 +375 1 5.70683 4.9474 5.70386 9.48927 0.653977 8.8924 +376 1 4.96412 5.79635 5.67508 -8.29845 -17.1654 19.2091 +377 1 6.48765 4.91573 4.91811 9.87445 -1.02048 -0.929801 +378 1 7.42803 5.76565 5.01887 -36.8924 9.29378 -39.8178 +379 1 7.31535 5.01349 5.75729 -2.96639 -15.6116 3.19898 +380 1 6.51112 5.80276 5.76292 -0.511839 0.0343249 -1.86567 +381 1 0.0752499 6.50198 4.93503 -9.95853 14.5519 3.18185 +382 1 0.749032 7.44313 4.93057 9.36322 -4.26106 -6.17112 +383 1 0.799308 6.59761 5.72007 7.23025 -2.947 1.48543 +384 1 0.0646916 7.47006 5.72188 -15.7332 -12.5303 9.25543 +385 1 1.64476 6.54961 5.03014 -20.9538 30.4927 -38.3434 +386 1 2.45435 7.39325 4.88002 3.42796 3.8663 5.03137 +387 1 2.4342 6.59097 5.67369 23.2905 17.249 22.0616 +388 1 1.54778 7.4679 5.8363 19.3115 -12.9738 -21.1698 +389 1 3.32159 6.57391 4.94635 0.920374 5.37222 -4.76541 +390 1 4.12734 7.43087 4.87631 0.0949958 -12.9619 14.1535 +391 1 4.03648 6.57336 5.82487 9.67898 -2.57585 -4.33725 +392 1 3.37401 7.44443 5.83215 -8.90767 -10.0262 -16.7558 +393 1 4.95785 6.5313 4.96795 -5.28369 20.3288 -12.6073 +394 1 5.72446 7.44815 4.95617 -0.295615 -4.81227 -6.28599 +395 1 5.67507 6.56368 5.75557 19.5363 2.36566 3.12879 +396 1 4.99604 7.36578 5.82253 -12.0795 7.56208 -16.0156 +397 1 6.47952 6.65183 4.84549 7.81673 -1.192 17.7565 +398 1 7.49045 7.38842 4.86267 -3.31154 -1.72952 10.3926 +399 1 7.31515 6.64393 5.7627 1.65473 -7.46902 -9.80451 +400 1 6.51213 7.44705 5.67942 6.88055 -5.46286 6.12471 +401 1 0.0806264 0.0886591 6.67061 2.86389 -53.8636 -44.0246 +402 1 0.883633 0.899989 6.55658 -11.6958 -11.9156 5.39561 +403 1 0.88757 0.0447352 7.4623 -6.5852 -8.63148 -1.54458 +404 1 0.00589996 0.782701 7.30583 -3.57511 51.2033 48.3924 +405 1 1.70878 0.0185969 6.53425 -9.91562 -0.171369 19.1044 +406 1 2.47179 0.820184 6.65916 -10.0875 0.778119 -25.3377 +407 1 2.53937 0.0160974 7.34796 -3.95783 -6.52463 5.98309 +408 1 1.62994 0.765044 7.35659 9.0133 10.535 7.11032 +409 1 3.30704 0.041501 6.48376 -12.5346 2.59741 23.4233 +410 1 4.02443 0.849646 6.63591 28.9911 -27.1685 -8.99322 +411 1 4.05271 0.0416361 7.37632 0.533135 -1.75778 -2.17869 +412 1 3.19386 0.898466 7.37702 15.4736 -11.3366 18.5812 +413 1 4.93306 0.0872445 6.49555 4.8751 -33.7979 36.6921 +414 1 5.84884 0.883258 6.55834 -5.60524 -28.829 17.1111 +415 1 5.81564 0.024621 7.40384 -2.36039 -5.56484 -6.47242 +416 1 4.961 0.816895 7.40894 -1.64345 1.03662 -2.05135 +417 1 6.67176 0.000709987 6.50931 -8.49107 -0.789231 11.0199 +418 1 7.42872 0.868407 6.55728 -5.95092 -10.3429 1.39671 +419 1 7.36138 8.18623 7.46478 9.04825 4.48366 -10.7424 +420 1 6.59985 0.825831 7.39669 4.88737 -2.34866 2.27965 +421 1 8.14416 1.67759 6.49013 32.825 -1.32457 17.7447 +422 1 0.9037 2.40379 6.60352 -22.6991 13.3728 -5.6252 +423 1 0.83815 1.6821 7.34463 -6.45777 -9.82884 14.5288 +424 1 8.19206 2.55987 7.48041 1.09967 -24.6646 -31.5822 +425 1 1.61029 1.6565 6.61062 19.3859 -4.50632 -8.40911 +426 1 2.39042 2.47779 6.49991 10.3869 -7.14038 20.8685 +427 1 2.43336 1.66264 7.31159 -0.298923 7.67874 9.60508 +428 1 1.68521 2.53757 7.43341 0.0908995 -20.3899 -19.4953 +429 1 3.34574 1.55658 6.57542 -29.1499 40.141 -5.99747 +430 1 4.09567 2.50385 6.58715 2.92988 -17.1157 8.90269 +431 1 4.06967 1.60141 7.36073 8.28003 9.68724 13.2999 +432 1 3.26291 2.44686 7.41755 -1.72761 -1.27824 0.484775 +433 1 5.02343 1.63061 6.57358 -10.9076 3.24904 2.06921 +434 1 5.8117 2.52535 6.48584 -2.10788 -3.23133 8.48842 +435 1 5.76381 1.64883 7.37339 7.06147 -0.584215 3.21917 +436 1 4.99697 2.44099 7.45915 -1.75923 11.2498 -19.4182 +437 1 6.62044 1.59458 6.63611 -5.65576 11.9066 -13.6974 +438 1 7.40085 2.40641 6.52565 -4.26631 17.0681 5.6259 +439 1 7.4086 1.68173 7.30269 7.67403 -2.22025 20.1658 +440 1 6.56414 2.4958 7.48155 2.02857 -0.65966 -9.40352 +441 1 8.16172 3.22 6.50779 31.0613 6.17733 37.0029 +442 1 0.778923 4.13348 6.47989 7.10682 -1.13444 17.3069 +443 1 0.731543 3.38344 7.32104 8.57141 -10.8353 -0.596329 +444 1 8.20703 4.11651 7.39737 -10.5501 6.3503 -2.89453 +445 1 1.5556 3.22612 6.62242 10.8567 18.3759 1.80723 +446 1 2.43596 4.07218 6.65191 19.5996 1.93234 -23.7547 +447 1 2.42128 3.38357 7.48855 6.46322 -13.7769 -4.42002 +448 1 1.70183 4.1306 7.3251 -28.6202 8.98318 18.3174 +449 1 3.23368 3.21004 6.55845 -1.66335 0.810928 5.98502 +450 1 4.02817 4.01745 6.59179 9.73332 14.3603 -1.234 +451 1 4.04024 3.24371 7.33596 9.19519 -2.61436 13.2612 +452 1 3.33578 4.03204 7.3761 -11.8519 11.1256 7.31388 +453 1 4.84615 3.34919 6.50516 30.474 -3.21025 16.5113 +454 1 5.79338 4.10407 6.63223 -1.4488 4.34379 -6.9657 +455 1 5.71769 3.33306 7.36343 3.56485 -8.31237 5.17357 +456 1 4.89884 4.06687 7.36632 1.94898 -1.38193 2.81677 +457 1 6.61297 3.34048 6.58436 -38.9416 -40.8203 -5.50523 +458 1 7.30794 4.01061 6.56591 40.2005 61.5018 -17.6954 +459 1 7.37741 3.36957 7.31145 38.0889 -52.6112 27.9446 +460 1 6.66665 4.01974 7.42717 -35.3166 42.1921 1.19147 +461 1 0.0452175 4.90338 6.62118 -6.71352 5.92623 -3.01906 +462 1 0.869367 5.66645 6.62279 -29.6122 19.3042 -24.6336 +463 1 0.858776 5.03104 7.45654 -16.814 -24.2615 8.51744 +464 1 8.14658 5.74936 7.4724 2.5583 -5.40279 -7.71149 +465 1 1.59957 4.95319 6.53572 14.873 -15.6204 -6.12191 +466 1 2.54529 5.66468 6.59785 -23.4011 43.3591 -27.461 +467 1 2.4961 5.03005 7.34302 -11.668 -32.1864 28.6337 +468 1 1.60544 5.69113 7.30132 37.8442 13.2739 23.8753 +469 1 3.24356 4.96073 6.59142 26.8133 -25.0989 -5.08933 +470 1 4.09781 5.67439 6.52285 2.63557 7.15813 7.05447 +471 1 4.18105 4.86276 7.35501 -9.07005 4.72655 -1.53462 +472 1 3.36767 5.65499 7.49749 6.09099 26.0319 -27.9028 +473 1 5.01795 4.94278 6.59504 -2.00637 0.995546 -1.6799 +474 1 5.7841 5.85399 6.63871 4.06216 -12.0086 -14.5693 +475 1 5.83404 5.02565 7.38856 -29.8707 -40.8918 -9.03319 +476 1 4.9605 5.83878 7.31445 -12.603 -27.5006 25.6094 +477 1 6.59477 4.88222 6.67554 -4.07568 1.88148 -17.9737 +478 1 7.35313 5.77701 6.52551 0.181186 3.4052 7.13046 +479 1 7.348 4.89641 7.37973 13.5892 1.99375 8.82978 +480 1 6.49663 5.74982 7.4422 46.6685 29.9241 -18.7201 +481 1 0.0491078 6.53098 6.47716 -5.83531 -0.141054 6.60445 +482 1 0.791488 7.40292 6.50563 -8.70546 -0.874788 22.49 +483 1 0.919931 6.51323 7.45776 -11.5314 25.4002 -28.1718 +484 1 0.0481113 7.40468 7.43229 -11.5944 -5.37754 -18.7674 +485 1 1.63473 6.52345 6.62888 -0.301482 5.86022 -13.1885 +486 1 2.54325 7.3746 6.52095 -7.01617 -1.6126 8.94816 +487 1 2.42821 6.65367 7.34715 -0.0947462 -6.49261 12.3075 +488 1 1.66344 7.43005 7.38619 -4.64698 1.83667 -2.7903 +489 1 3.21223 6.51896 6.65614 12.5802 -0.344258 -7.45446 +490 1 4.18524 7.3836 6.50889 -0.948752 5.15796 16.6381 +491 1 4.03479 6.58867 7.43482 10.4531 -7.07785 -21.0648 +492 1 3.31132 7.44815 7.43351 -1.0832 -4.66317 -4.42978 +493 1 5.00814 6.58691 6.66459 -15.2308 20.9466 -24.4589 +494 1 5.70889 7.39626 6.56563 14.4769 6.85637 10.1092 +495 1 5.73775 6.567 7.43094 6.72915 9.63092 8.95959 +496 1 4.91068 7.49261 7.37168 0.330155 -8.28614 -9.94049 +497 1 6.53726 6.65021 6.66417 -1.59265 -6.08794 -3.67401 +498 1 7.37246 7.29875 6.57444 7.56141 13.3939 8.59342 +499 1 7.35261 6.58373 7.49207 23.0737 -16.5957 -35.2353 +500 1 6.60589 7.39349 7.49219 -10.7096 3.92482 -19.5185 diff --git a/examples/mdi/dump.17Jun22.snapshot.alone.1 b/examples/mdi/dump.17Jun22.snapshot.alone.1 new file mode 100644 index 0000000000..3e7ef0a29b --- /dev/null +++ b/examples/mdi/dump.17Jun22.snapshot.alone.1 @@ -0,0 +1,2036 @@ +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +500 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 0 0 0 -1.06581e-14 -1.06581e-14 -1.00753e-14 +2 1 0.839798 0.839798 0 2.66454e-15 3.34455e-15 -9.76996e-15 +3 1 0.839798 0 0.839798 2.66454e-15 -1.05471e-14 4.56579e-15 +4 1 0 0.839798 0.839798 -1.15463e-14 2.88658e-15 3.44169e-15 +5 1 1.6796 0 0 -4.09395e-16 -9.76996e-15 -1.04361e-14 +6 1 2.51939 0.839798 0 -4.23273e-16 2.66454e-15 -1.06581e-14 +7 1 2.51939 0 0.839798 -7.00828e-16 -1.06581e-14 2.9976e-15 +8 1 1.6796 0.839798 0.839798 -4.3715e-16 3.10862e-15 3.1225e-15 +9 1 3.35919 0 0 1.28439e-14 -1.06581e-14 -1.04361e-14 +10 1 4.19899 0.839798 0 -2.25236e-14 2.66454e-15 -7.99361e-15 +11 1 4.19899 0 0.839798 -2.34118e-14 -8.88178e-15 2.55351e-15 +12 1 3.35919 0.839798 0.839798 1.37182e-14 3.10862e-15 4.23273e-15 +13 1 5.03879 0 0 2.77556e-17 -7.99361e-15 -7.99361e-15 +14 1 5.87859 0.839798 0 2.26555e-14 2.66454e-15 -7.99361e-15 +15 1 5.87859 0 0.839798 2.16702e-14 -7.99361e-15 2.66454e-15 +16 1 5.03879 0.839798 0.839798 -4.09395e-16 2.88658e-15 2.90046e-15 +17 1 6.71838 0 0 -3.33067e-15 -9.63118e-15 -9.74221e-15 +18 1 7.55818 0.839798 0 4.44089e-16 2.55351e-15 -9.32587e-15 +19 1 7.55818 0 0.839798 0 -1.02141e-14 3.21965e-15 +20 1 6.71838 0.839798 0.839798 -2.94209e-15 2.90046e-15 4.02456e-15 +21 1 0 1.6796 0 -1.15463e-14 0 -1.04361e-14 +22 1 0.839798 2.51939 0 2.88658e-15 -2.77556e-17 -9.76996e-15 +23 1 0.839798 1.6796 0.839798 2.33147e-15 2.22045e-16 3.34455e-15 +24 1 0 2.51939 0.839798 -1.06581e-14 -7.21645e-16 2.9976e-15 +25 1 1.6796 1.6796 0 -5.06539e-16 6.245e-17 -9.76996e-15 +26 1 2.51939 2.51939 0 -2.11636e-15 -1.72778e-15 -9.76996e-15 +27 1 2.51939 1.6796 0.839798 -1.2837e-15 9.08995e-16 2.88658e-15 +28 1 1.6796 2.51939 0.839798 3.53884e-16 -2.0331e-15 2.88658e-15 +29 1 3.35919 1.6796 0 1.34545e-14 3.46945e-17 -7.99361e-15 +30 1 4.19899 2.51939 0 -2.30926e-14 -1.85268e-15 -7.99361e-15 +31 1 4.19899 1.6796 0.839798 -2.24404e-14 -2.08167e-16 3.33067e-15 +32 1 3.35919 2.51939 0.839798 1.45925e-14 -1.36002e-15 3.33067e-15 +33 1 5.03879 1.6796 0 2.01228e-16 1.66533e-16 -7.10543e-15 +34 1 5.87859 2.51939 0 2.12677e-14 -1.74166e-15 -7.99361e-15 +35 1 5.87859 1.6796 0.839798 1.98383e-14 1.17961e-15 3.10862e-15 +36 1 5.03879 2.51939 0.839798 3.40006e-16 -2.80331e-15 2.88658e-15 +37 1 6.71838 1.6796 0 -3.10862e-15 -1.66533e-16 -8.10463e-15 +38 1 7.55818 2.51939 0 8.88178e-16 -1.33227e-15 -9.32587e-15 +39 1 7.55818 1.6796 0.839798 -8.04912e-16 1.94289e-16 3.33067e-15 +40 1 6.71838 2.51939 0.839798 -3.10862e-15 -1.66533e-15 3.56659e-15 +41 1 0 3.35919 0 -1.06581e-14 1.28786e-14 -9.54792e-15 +42 1 0.839798 4.19899 0 2.66454e-15 -2.24404e-14 -8.88178e-15 +43 1 0.839798 3.35919 0.839798 2.33147e-15 1.43774e-14 4.01068e-15 +44 1 0 4.19899 0.839798 -8.88178e-15 -2.32037e-14 2.55351e-15 +45 1 1.6796 3.35919 0 -8.53484e-16 1.47174e-14 -9.76996e-15 +46 1 2.51939 4.19899 0 -1.79717e-15 -2.32175e-14 -7.10543e-15 +47 1 2.51939 3.35919 0.839798 -5.06539e-16 1.51476e-14 3.55271e-15 +48 1 1.6796 4.19899 0.839798 -2.08167e-16 -2.40918e-14 3.33067e-15 +49 1 3.35919 3.35919 0 1.2608e-14 1.419e-14 -7.99361e-15 +50 1 4.19899 4.19899 0 -2.28706e-14 -2.25653e-14 -5.32907e-15 +51 1 4.19899 3.35919 0.839798 -2.21004e-14 1.13937e-14 2.88658e-15 +52 1 3.35919 4.19899 0.839798 1.249e-14 -2.21975e-14 2.88658e-15 +53 1 5.03879 3.35919 0 -2.22045e-16 1.14422e-14 -6.21725e-15 +54 1 5.87859 4.19899 0 2.22322e-14 -2.22461e-14 -5.32907e-15 +55 1 5.87859 3.35919 0.839798 2.14412e-14 1.27467e-14 2.88658e-15 +56 1 5.03879 4.19899 0.839798 -2.08167e-16 -2.11983e-14 3.10862e-15 +57 1 6.71838 3.35919 0 -3.60822e-15 1.32949e-14 -8.04912e-15 +58 1 7.55818 4.19899 0 8.88178e-16 -2.44249e-14 -7.10543e-15 +59 1 7.55818 3.35919 0.839798 1.66533e-16 1.40443e-14 3.10862e-15 +60 1 6.71838 4.19899 0.839798 -3.05311e-15 -2.40641e-14 2.45637e-15 +61 1 0 5.03879 0 -7.10543e-15 6.66134e-16 -7.32747e-15 +62 1 0.839798 5.87859 0 2.66454e-15 2.28706e-14 -7.10543e-15 +63 1 0.839798 5.03879 0.839798 2.55351e-15 -2.77556e-16 2.67841e-15 +64 1 0 5.87859 0.839798 -9.76996e-15 2.18159e-14 2.66454e-15 +65 1 1.6796 5.03879 0 8.32667e-17 -9.92262e-16 -6.21725e-15 +66 1 2.51939 5.87859 0 -2.08167e-15 2.16008e-14 -7.10543e-15 +67 1 2.51939 5.03879 0.839798 -1.72085e-15 3.81639e-16 3.10862e-15 +68 1 1.6796 5.87859 0.839798 -8.74301e-16 2.02824e-14 3.10862e-15 +69 1 3.35919 5.03879 0 1.08871e-14 -1.80411e-16 -6.21725e-15 +70 1 4.19899 5.87859 0 -2.27804e-14 2.17187e-14 -4.44089e-15 +71 1 4.19899 5.03879 0.839798 -1.95469e-14 -1.15186e-15 2.88658e-15 +72 1 3.35919 5.87859 0.839798 1.19973e-14 2.21143e-14 2.88658e-15 +73 1 5.03879 5.03879 0 1.17961e-16 6.8695e-16 -3.55271e-15 +74 1 5.87859 5.87859 0 2.17604e-14 2.22114e-14 -5.32907e-15 +75 1 5.87859 5.03879 0.839798 1.9415e-14 3.747e-16 2.88658e-15 +76 1 5.03879 5.87859 0.839798 -6.52256e-16 1.92069e-14 2.88658e-15 +77 1 6.71838 5.03879 0 -2.38698e-15 4.64906e-16 -6.43929e-15 +78 1 7.55818 5.87859 0 0 2.26485e-14 -7.54952e-15 +79 1 7.55818 5.03879 0.839798 1.11022e-16 1.44329e-15 2.498e-15 +80 1 6.71838 5.87859 0.839798 -2.94209e-15 2.15661e-14 2.45637e-15 +81 1 0 6.71838 0 -1.06581e-14 -3.77476e-15 -9.60343e-15 +82 1 0.839798 7.55818 0 2.44249e-15 7.91034e-16 -1.00892e-14 +83 1 0.839798 6.71838 0.839798 2.33147e-15 -2.83107e-15 3.80251e-15 +84 1 0 7.55818 0.839798 -8.88178e-15 -2.22045e-16 3.05311e-15 +85 1 1.6796 6.71838 0 -8.04912e-16 -1.72085e-15 -8.99281e-15 +86 1 2.51939 7.55818 0 -1.51268e-15 6.66134e-16 -9.54792e-15 +87 1 2.51939 6.71838 0.839798 -7.91034e-16 -2.83801e-15 3.56659e-15 +88 1 1.6796 7.55818 0.839798 2.08167e-16 2.77556e-16 3.33067e-15 +89 1 3.35919 6.71838 0 1.24623e-14 -2.22045e-15 -8.04912e-15 +90 1 4.19899 7.55818 0 -2.45221e-14 0 -7.99361e-15 +91 1 4.19899 6.71838 0.839798 -2.33563e-14 -4.89886e-15 2.45637e-15 +92 1 3.35919 7.55818 0.839798 1.30868e-14 8.88178e-16 2.88658e-15 +93 1 5.03879 6.71838 0 -4.02456e-16 -2.83107e-15 -6.43929e-15 +94 1 5.87859 7.55818 0 2.33563e-14 8.88178e-16 -7.10543e-15 +95 1 5.87859 6.71838 0.839798 2.1913e-14 -1.74166e-15 2.45637e-15 +96 1 5.03879 7.55818 0.839798 -2.08167e-16 -5.27356e-16 2.498e-15 +97 1 6.71838 6.71838 0 -2.83107e-15 -3.42781e-15 -7.10543e-15 +98 1 7.55818 7.55818 0 4.44089e-16 0 -8.88178e-15 +99 1 7.55818 6.71838 0.839798 5.55112e-17 -3.10862e-15 2.55351e-15 +100 1 6.71838 7.55818 0.839798 -2.88658e-15 5.27356e-16 2.56739e-15 +101 1 0 0 1.6796 -1.15463e-14 -1.04361e-14 -1.11022e-15 +102 1 0.839798 0.839798 1.6796 2.44249e-15 2.56739e-15 6.66134e-16 +103 1 0.839798 0 2.51939 2.66454e-15 -1.05471e-14 1.80411e-16 +104 1 0 0.839798 2.51939 -1.15463e-14 2.9976e-15 3.88578e-16 +105 1 1.6796 0 1.6796 1.73472e-16 -9.76996e-15 0 +106 1 2.51939 0.839798 1.6796 -1.71391e-15 2.66454e-15 3.88578e-16 +107 1 2.51939 0 2.51939 -1.6584e-15 -1.06581e-14 -1.4988e-15 +108 1 1.6796 0.839798 2.51939 2.63678e-16 3.10862e-15 -1.67227e-15 +109 1 3.35919 0 1.6796 1.41623e-14 -8.88178e-15 6.66134e-16 +110 1 4.19899 0.839798 1.6796 -2.18159e-14 2.44249e-15 -6.10623e-16 +111 1 4.19899 0 2.51939 -2.30371e-14 -7.99361e-15 -1.66533e-15 +112 1 3.35919 0.839798 2.51939 1.4419e-14 2.88658e-15 -1.90126e-15 +113 1 5.03879 0 1.6796 8.67362e-16 -8.88178e-15 8.88178e-16 +114 1 5.87859 0.839798 1.6796 2.02685e-14 2.44249e-15 1.02696e-15 +115 1 5.87859 0 2.51939 2.01159e-14 -8.88178e-15 -1.38778e-15 +116 1 5.03879 0.839798 2.51939 2.91434e-16 3.10862e-15 -1.45023e-15 +117 1 6.71838 0 1.6796 -2.52576e-15 -8.77076e-15 -9.02056e-17 +118 1 7.55818 0.839798 1.6796 3.747e-16 2.16493e-15 1.04083e-16 +119 1 7.55818 0 2.51939 1.33227e-15 -9.76996e-15 -1.9984e-15 +120 1 6.71838 0.839798 2.51939 -3.10862e-15 2.90046e-15 -2.10942e-15 +121 1 0 1.6796 1.6796 -1.28786e-14 8.88178e-16 6.66134e-16 +122 1 0.839798 2.51939 1.6796 2.33147e-15 -1.43635e-15 1.11022e-16 +123 1 0.839798 1.6796 2.51939 2.66454e-15 7.35523e-16 -1.30451e-15 +124 1 0 2.51939 2.51939 -1.06581e-14 -7.49401e-16 -1.44329e-15 +125 1 1.6796 1.6796 1.6796 2.22045e-16 -1.67921e-15 5.96745e-16 +126 1 2.51939 2.51939 1.6796 -8.95117e-16 -2.39392e-15 -1.3739e-15 +127 1 2.51939 1.6796 2.51939 -9.22873e-16 1.38778e-17 -1.17267e-15 +128 1 1.6796 2.51939 2.51939 1.38778e-16 -1.26982e-15 -2.16493e-15 +129 1 3.35919 1.6796 1.6796 1.44329e-14 -1.58207e-15 5.27356e-16 +130 1 4.19899 2.51939 1.6796 -2.17534e-14 -1.89432e-15 -4.85723e-16 +131 1 4.19899 1.6796 2.51939 -2.2024e-14 4.64906e-16 -2.11636e-15 +132 1 3.35919 2.51939 2.51939 1.47937e-14 -1.33227e-15 -2.23432e-15 +133 1 5.03879 1.6796 1.6796 6.38378e-16 -4.78784e-16 8.46545e-16 +134 1 5.87859 2.51939 1.6796 2.05322e-14 -1.4086e-15 2.28983e-16 +135 1 5.87859 1.6796 2.51939 2.02546e-14 -2.56739e-16 -2.07473e-15 +136 1 5.03879 2.51939 2.51939 5.82867e-16 -1.91513e-15 -2.16493e-15 +137 1 6.71838 1.6796 1.6796 -2.16493e-15 -9.4369e-16 5.55112e-17 +138 1 7.55818 2.51939 1.6796 -4.44089e-16 -1.11022e-15 -2.77556e-17 +139 1 7.55818 1.6796 2.51939 4.44089e-16 -6.93889e-18 -2.22045e-15 +140 1 6.71838 2.51939 2.51939 -3.27516e-15 -1.67921e-15 -2.38698e-15 +141 1 0 3.35919 1.6796 -1.11022e-14 1.39888e-14 -2.22045e-16 +142 1 0.839798 4.19899 1.6796 2.44249e-15 -2.1684e-14 -6.10623e-16 +143 1 0.839798 3.35919 2.51939 2.44249e-15 1.49047e-14 -1.83187e-15 +144 1 0 4.19899 2.51939 -8.88178e-15 -2.22322e-14 -1.60982e-15 +145 1 1.6796 3.35919 1.6796 2.08167e-16 1.37251e-14 5.41234e-16 +146 1 2.51939 4.19899 1.6796 -1.72778e-15 -2.28081e-14 -1.32533e-15 +147 1 2.51939 3.35919 2.51939 -9.92262e-16 1.42247e-14 -1.29757e-15 +148 1 1.6796 4.19899 2.51939 6.93889e-18 -2.16632e-14 -2.92821e-15 +149 1 3.35919 3.35919 1.6796 1.39194e-14 1.31006e-14 3.46945e-16 +150 1 4.19899 4.19899 1.6796 -2.1684e-14 -2.2142e-14 -1.26982e-15 +151 1 4.19899 3.35919 2.51939 -2.27457e-14 1.10675e-14 -2.81025e-15 +152 1 3.35919 4.19899 2.51939 1.17337e-14 -2.23849e-14 -3.15026e-15 +153 1 5.03879 3.35919 1.6796 -6.93889e-18 1.12688e-14 1.38778e-16 +154 1 5.87859 4.19899 1.6796 2.0213e-14 -2.25167e-14 2.28983e-16 +155 1 5.87859 3.35919 2.51939 2.08236e-14 1.21292e-14 -2.5327e-15 +156 1 5.03879 4.19899 2.51939 1.38778e-17 -1.97481e-14 -3.59435e-15 +157 1 6.71838 3.35919 1.6796 -2.96291e-15 1.29619e-14 -1.11716e-15 +158 1 7.55818 4.19899 1.6796 2.22045e-16 -2.33147e-14 -4.996e-16 +159 1 7.55818 3.35919 2.51939 1.33227e-15 1.33227e-14 -2.66454e-15 +160 1 6.71838 4.19899 2.51939 -3.27516e-15 -2.33147e-14 -2.84495e-15 +161 1 0 5.03879 1.6796 -7.10543e-15 4.44089e-16 0 +162 1 0.839798 5.87859 1.6796 2.44249e-15 2.08375e-14 7.21645e-16 +163 1 0.839798 5.03879 2.51939 2.88658e-15 2.63678e-16 -1.13798e-15 +164 1 0 5.87859 2.51939 -7.99361e-15 2.03171e-14 -1.44329e-15 +165 1 1.6796 5.03879 1.6796 2.56739e-16 8.60423e-16 8.04912e-16 +166 1 2.51939 5.87859 1.6796 -9.64506e-16 2.08375e-14 -7.35523e-16 +167 1 2.51939 5.03879 2.51939 -2.04003e-15 -4.57967e-16 -2.84495e-16 +168 1 1.6796 5.87859 2.51939 6.93889e-18 2.03101e-14 -7.91034e-16 +169 1 3.35919 5.03879 1.6796 1.12549e-14 2.08167e-17 1.08247e-15 +170 1 4.19899 5.87859 1.6796 -2.15591e-14 2.06987e-14 9.57567e-16 +171 1 4.19899 5.03879 2.51939 -1.96579e-14 4.30211e-16 -2.72699e-15 +172 1 3.35919 5.87859 2.51939 1.23929e-14 2.06432e-14 -2.2482e-15 +173 1 5.03879 5.03879 1.6796 2.77556e-17 -1.38778e-16 1.20737e-15 +174 1 5.87859 5.87859 1.6796 2.07542e-14 2.02408e-14 7.70217e-16 +175 1 5.87859 5.03879 2.51939 1.86587e-14 6.52256e-16 -1.7833e-15 +176 1 5.03879 5.87859 2.51939 -2.08167e-16 1.92762e-14 -1.33227e-15 +177 1 6.71838 5.03879 1.6796 -2.42167e-15 -1.31839e-16 -3.33067e-16 +178 1 7.55818 5.87859 1.6796 -2.22045e-16 2.19824e-14 2.22045e-16 +179 1 7.55818 5.03879 2.51939 -4.44089e-16 1.22125e-15 -1.9984e-15 +180 1 6.71838 5.87859 2.51939 -3.10862e-15 2.20657e-14 -2.19269e-15 +181 1 0 6.71838 1.6796 -1.02141e-14 -2.88658e-15 -6.66134e-16 +182 1 0.839798 7.55818 1.6796 1.9984e-15 6.38378e-16 2.22045e-16 +183 1 0.839798 6.71838 2.51939 2.66454e-15 -3.10862e-15 -2.08167e-15 +184 1 0 7.55818 2.51939 -9.76996e-15 4.44089e-16 -1.88738e-15 +185 1 1.6796 6.71838 1.6796 1.94289e-16 -2.31759e-15 1.249e-16 +186 1 2.51939 7.55818 1.6796 -1.249e-15 -6.17562e-16 5.55112e-17 +187 1 2.51939 6.71838 2.51939 -1.19349e-15 -3.10862e-15 -2.08167e-15 +188 1 1.6796 7.55818 2.51939 -2.22045e-16 1.33227e-15 -2.66454e-15 +189 1 3.35919 6.71838 1.6796 1.34198e-14 -2.02616e-15 -6.245e-17 +190 1 4.19899 7.55818 1.6796 -2.38282e-14 -4.71845e-16 1.45717e-16 +191 1 4.19899 6.71838 2.51939 -2.43278e-14 -4.60743e-15 -3.88578e-15 +192 1 3.35919 7.55818 2.51939 1.29896e-14 1.9984e-15 -2.22045e-15 +193 1 5.03879 6.71838 1.6796 -6.245e-17 -1.65146e-15 2.35922e-16 +194 1 5.87859 7.55818 1.6796 2.23294e-14 1.13798e-15 -6.93889e-18 +195 1 5.87859 6.71838 2.51939 2.15869e-14 -2.9976e-15 -2.63678e-15 +196 1 5.03879 7.55818 2.51939 -2.22045e-16 -2.22045e-16 -1.77636e-15 +197 1 6.71838 6.71838 1.6796 -2.62984e-15 -2.59515e-15 -1.47798e-15 +198 1 7.55818 7.55818 1.6796 4.44089e-16 2.22045e-16 -8.32667e-17 +199 1 7.55818 6.71838 2.51939 8.88178e-16 -2.27596e-15 -2.66454e-15 +200 1 6.71838 7.55818 2.51939 -2.9976e-15 7.91034e-16 -1.91513e-15 +201 1 0 0 3.35919 -1.06581e-14 -1.04361e-14 1.35447e-14 +202 1 0.839798 0.839798 3.35919 2.66454e-15 2.67841e-15 1.50435e-14 +203 1 0.839798 0 4.19899 2.66454e-15 -8.77076e-15 -2.26139e-14 +204 1 0 0.839798 4.19899 -8.88178e-15 2.88658e-15 -2.24265e-14 +205 1 1.6796 0 3.35919 1.73472e-16 -8.88178e-15 1.42109e-14 +206 1 2.51939 0.839798 3.35919 -1.83881e-15 2.77556e-15 1.55431e-14 +207 1 2.51939 0 4.19899 -1.67227e-15 -7.99361e-15 -2.32037e-14 +208 1 1.6796 0.839798 4.19899 -1.8735e-16 3.33067e-15 -2.28637e-14 +209 1 3.35919 0 3.35919 1.37182e-14 -7.99361e-15 1.44329e-14 +210 1 4.19899 0.839798 3.35919 -2.30232e-14 2.66454e-15 1.19071e-14 +211 1 4.19899 0 4.19899 -2.27665e-14 -5.32907e-15 -2.27041e-14 +212 1 3.35919 0.839798 4.19899 1.24276e-14 2.88658e-15 -2.27457e-14 +213 1 5.03879 0 3.35919 -2.08167e-17 -7.99361e-15 1.11022e-14 +214 1 5.87859 0.839798 3.35919 2.2489e-14 2.55351e-15 1.36002e-14 +215 1 5.87859 0 4.19899 2.21143e-14 -5.32907e-15 -2.24265e-14 +216 1 5.03879 0.839798 4.19899 -1.08941e-15 3.55271e-15 -2.22461e-14 +217 1 6.71838 0 3.35919 -2.47025e-15 -8.77076e-15 1.29619e-14 +218 1 7.55818 0.839798 3.35919 -1.11022e-15 2.60902e-15 1.4766e-14 +219 1 7.55818 0 4.19899 1.33227e-15 -6.43929e-15 -2.4647e-14 +220 1 6.71838 0.839798 4.19899 -2.38698e-15 2.67841e-15 -2.39531e-14 +221 1 0 1.6796 3.35919 -1.11022e-14 -2.22045e-16 1.44329e-14 +222 1 0.839798 2.51939 3.35919 2.77556e-15 -4.64906e-16 1.52378e-14 +223 1 0.839798 1.6796 4.19899 2.88658e-15 2.498e-16 -2.32592e-14 +224 1 0 2.51939 4.19899 -8.88178e-15 -1.60982e-15 -2.32592e-14 +225 1 1.6796 1.6796 3.35919 2.22045e-16 -7.91034e-16 1.5779e-14 +226 1 2.51939 2.51939 3.35919 -1.4086e-15 -1.02002e-15 1.46133e-14 +227 1 2.51939 1.6796 4.19899 -1.39472e-15 3.95517e-16 -2.30857e-14 +228 1 1.6796 2.51939 4.19899 -8.67362e-16 -1.45023e-15 -2.42237e-14 +229 1 3.35919 1.6796 3.35919 1.39888e-14 -2.77556e-17 1.57235e-14 +230 1 4.19899 2.51939 3.35919 -2.32939e-14 -1.64452e-15 1.24276e-14 +231 1 4.19899 1.6796 4.19899 -2.19755e-14 -9.08995e-16 -2.30302e-14 +232 1 3.35919 2.51939 4.19899 1.17822e-14 -2.00534e-15 -2.40433e-14 +233 1 5.03879 1.6796 3.35919 -2.498e-16 -9.22873e-16 1.29757e-14 +234 1 5.87859 2.51939 3.35919 2.13649e-14 -8.67362e-16 1.27398e-14 +235 1 5.87859 1.6796 4.19899 2.08236e-14 -7.42462e-16 -2.31828e-14 +236 1 5.03879 2.51939 4.19899 -4.30211e-16 -1.67227e-15 -2.22253e-14 +237 1 6.71838 1.6796 3.35919 -3.19883e-15 -4.996e-16 1.39264e-14 +238 1 7.55818 2.51939 3.35919 -4.44089e-16 -1.9984e-15 1.24345e-14 +239 1 7.55818 1.6796 4.19899 -4.44089e-16 -5.06539e-16 -2.39808e-14 +240 1 6.71838 2.51939 4.19899 -2.44249e-15 -1.47105e-15 -2.40641e-14 +241 1 0 3.35919 3.35919 -1.11022e-14 1.33227e-14 1.31006e-14 +242 1 0.839798 4.19899 3.35919 2.66454e-15 -2.26555e-14 1.12133e-14 +243 1 0.839798 3.35919 4.19899 2.44249e-15 1.28925e-14 -2.26208e-14 +244 1 0 4.19899 4.19899 -6.21725e-15 -2.26485e-14 -2.26485e-14 +245 1 1.6796 3.35919 3.35919 2.08167e-16 1.3281e-14 1.52794e-14 +246 1 2.51939 4.19899 3.35919 -2.17187e-15 -2.33494e-14 1.22957e-14 +247 1 2.51939 3.35919 4.19899 -1.94983e-15 1.21569e-14 -2.20726e-14 +248 1 1.6796 4.19899 4.19899 -5.20417e-16 -2.2489e-14 -2.38767e-14 +249 1 3.35919 3.35919 3.35919 1.28092e-14 1.24345e-14 1.42109e-14 +250 1 4.19899 4.19899 3.35919 -2.29677e-14 -2.35575e-14 8.33361e-15 +251 1 4.19899 3.35919 4.19899 -2.33702e-14 9.08301e-15 -2.33355e-14 +252 1 3.35919 4.19899 4.19899 9.67976e-15 -2.36547e-14 -2.46539e-14 +253 1 5.03879 3.35919 3.35919 -2.28983e-16 1.06026e-14 1.14353e-14 +254 1 5.87859 4.19899 3.35919 2.19408e-14 -2.21698e-14 8.51402e-15 +255 1 5.87859 3.35919 4.19899 2.15522e-14 1.01238e-14 -2.328e-14 +256 1 5.03879 4.19899 4.19899 -5.20417e-16 -2.11775e-14 -2.23085e-14 +257 1 6.71838 3.35919 3.35919 -3.1225e-15 1.22957e-14 1.31978e-14 +258 1 7.55818 4.19899 3.35919 -1.11022e-15 -2.4647e-14 1.05471e-14 +259 1 7.55818 3.35919 4.19899 -8.88178e-16 1.113e-14 -2.53131e-14 +260 1 6.71838 4.19899 4.19899 -3.60822e-15 -2.5091e-14 -2.32731e-14 +261 1 0 5.03879 3.35919 -7.10543e-15 -2.22045e-16 1.15463e-14 +262 1 0.839798 5.87859 3.35919 2.55351e-15 2.28359e-14 1.37113e-14 +263 1 0.839798 5.03879 4.19899 2.88658e-15 -1.05471e-15 -2.20102e-14 +264 1 0 5.87859 4.19899 -5.32907e-15 2.21212e-14 -2.25375e-14 +265 1 1.6796 5.03879 3.35919 2.56739e-16 -2.498e-16 1.26843e-14 +266 1 2.51939 5.87859 3.35919 -1.31145e-15 2.16702e-14 1.30659e-14 +267 1 2.51939 5.03879 4.19899 -2.06085e-15 8.04912e-16 -2.10873e-14 +268 1 1.6796 5.87859 4.19899 -7.63278e-17 2.17118e-14 -2.12261e-14 +269 1 3.35919 5.03879 3.35919 1.10328e-14 -2.01228e-16 1.11994e-14 +270 1 4.19899 5.87859 3.35919 -2.29886e-14 2.15314e-14 1.08039e-14 +271 1 4.19899 5.03879 4.19899 -2.02338e-14 -4.92661e-16 -2.14065e-14 +272 1 3.35919 5.87859 4.19899 1.03459e-14 2.19963e-14 -2.39878e-14 +273 1 5.03879 5.03879 3.35919 -1.94289e-16 -8.04912e-16 8.64586e-15 +274 1 5.87859 5.87859 3.35919 2.18645e-14 2.20171e-14 1.02141e-14 +275 1 5.87859 5.03879 4.19899 1.98036e-14 1.38778e-16 -2.15869e-14 +276 1 5.03879 5.87859 4.19899 -3.05311e-16 1.94428e-14 -2.04628e-14 +277 1 6.71838 5.03879 3.35919 -2.35922e-15 -3.53884e-16 1.02071e-14 +278 1 7.55818 5.87859 3.35919 -8.88178e-16 2.28706e-14 1.02141e-14 +279 1 7.55818 5.03879 4.19899 -1.33227e-15 -3.05311e-16 -2.33147e-14 +280 1 6.71838 5.87859 4.19899 -3.27516e-15 2.23987e-14 -2.53547e-14 +281 1 0 6.71838 3.35919 -9.32587e-15 -3.77476e-15 1.31006e-14 +282 1 0.839798 7.55818 3.35919 2.33147e-15 1.13798e-15 1.40166e-14 +283 1 0.839798 6.71838 4.19899 2.66454e-15 -2.44249e-15 -2.37865e-14 +284 1 0 7.55818 4.19899 -6.21725e-15 -2.22045e-16 -2.50355e-14 +285 1 1.6796 6.71838 3.35919 1.94289e-16 -2.25514e-15 1.4419e-14 +286 1 2.51939 7.55818 3.35919 -1.59595e-15 -6.10623e-16 1.37668e-14 +287 1 2.51939 6.71838 4.19899 -8.95117e-16 -2.55351e-15 -2.28983e-14 +288 1 1.6796 7.55818 4.19899 -5.13478e-16 8.88178e-16 -2.44249e-14 +289 1 3.35919 6.71838 3.35919 1.20876e-14 -2.85189e-15 1.31353e-14 +290 1 4.19899 7.55818 3.35919 -2.47094e-14 -9.4369e-16 1.06026e-14 +291 1 4.19899 6.71838 4.19899 -2.41057e-14 -3.77476e-15 -2.26208e-14 +292 1 3.35919 7.55818 4.19899 1.06998e-14 1.55431e-15 -2.53131e-14 +293 1 5.03879 6.71838 3.35919 -6.245e-17 -3.36536e-15 1.00892e-14 +294 1 5.87859 7.55818 3.35919 2.328e-14 4.44089e-16 1.02696e-14 +295 1 5.87859 6.71838 4.19899 2.31135e-14 -3.33067e-15 -2.39531e-14 +296 1 5.03879 7.55818 4.19899 -6.93889e-17 2.22045e-16 -2.28706e-14 +297 1 6.71838 6.71838 3.35919 -2.63678e-15 -2.97679e-15 1.21014e-14 +298 1 7.55818 7.55818 3.35919 -4.44089e-16 2.22045e-16 1.2268e-14 +299 1 7.55818 6.71838 4.19899 0 -2.94209e-15 -2.70894e-14 +300 1 6.71838 7.55818 4.19899 -3.10862e-15 9.57567e-16 -2.65621e-14 +301 1 0 0 5.03879 -7.99361e-15 -7.77156e-15 6.66134e-16 +302 1 0.839798 0.839798 5.03879 2.44249e-15 2.56739e-15 2.22045e-16 +303 1 0.839798 0 5.87859 2.88658e-15 -7.88258e-15 2.30926e-14 +304 1 0 0.839798 5.87859 -8.88178e-15 2.88658e-15 2.23155e-14 +305 1 1.6796 0 5.03879 -3.67761e-16 -8.88178e-15 -6.66134e-16 +306 1 2.51939 0.839798 5.03879 -1.26982e-15 2.66454e-15 8.60423e-16 +307 1 2.51939 0 5.87859 -2.08167e-15 -7.99361e-15 2.15383e-14 +308 1 1.6796 0.839798 5.87859 2.63678e-16 2.88658e-15 2.07612e-14 +309 1 3.35919 0 5.03879 1.09704e-14 -7.10543e-15 1.11022e-15 +310 1 4.19899 0.839798 5.03879 -2.02546e-14 2.66454e-15 -4.996e-16 +311 1 4.19899 0 5.87859 -2.26694e-14 -5.32907e-15 2.09832e-14 +312 1 3.35919 0.839798 5.87859 1.21708e-14 2.88658e-15 2.16979e-14 +313 1 5.03879 0 5.03879 -3.1225e-16 -5.32907e-15 2.22045e-16 +314 1 5.87859 0.839798 5.03879 1.91652e-14 2.77556e-15 1.9984e-15 +315 1 5.87859 0 5.87859 2.18436e-14 -4.44089e-15 2.27041e-14 +316 1 5.03879 0.839798 5.87859 -3.747e-16 3.10862e-15 2.10387e-14 +317 1 6.71838 0 5.03879 -3.30291e-15 -5.27356e-15 8.32667e-17 +318 1 7.55818 0.839798 5.03879 -1.11022e-16 2.41474e-15 1.66533e-15 +319 1 7.55818 0 5.87859 8.88178e-16 -7.32747e-15 2.33147e-14 +320 1 6.71838 0.839798 5.87859 -2.27596e-15 2.67841e-15 2.30926e-14 +321 1 0 1.6796 5.03879 -7.99361e-15 -6.66134e-16 2.22045e-16 +322 1 0.839798 2.51939 5.03879 2.44249e-15 -1.1588e-15 5.82867e-16 +323 1 0.839798 1.6796 5.87859 2.66454e-15 7.35523e-16 2.19269e-14 +324 1 0 2.51939 5.87859 -7.99361e-15 -1.83187e-15 2.15938e-14 +325 1 1.6796 1.6796 5.03879 2.01228e-16 -5.27356e-16 1.97065e-15 +326 1 2.51939 2.51939 5.03879 -1.00614e-15 -1.22818e-15 4.16334e-17 +327 1 2.51939 1.6796 5.87859 -9.99201e-16 -1.38778e-17 2.22808e-14 +328 1 1.6796 2.51939 5.87859 1.52656e-16 -1.38778e-15 2.04003e-14 +329 1 3.35919 1.6796 5.03879 1.17545e-14 2.63678e-16 1.02696e-15 +330 1 4.19899 2.51939 5.03879 -2.02893e-14 -2.11636e-15 -4.30211e-16 +331 1 4.19899 1.6796 5.87859 -2.20032e-14 -9.02056e-16 2.10318e-14 +332 1 3.35919 2.51939 5.87859 1.25316e-14 -1.51962e-15 2.06363e-14 +333 1 5.03879 1.6796 5.03879 8.88178e-16 -5.6205e-16 2.7478e-15 +334 1 5.87859 2.51939 5.03879 1.8846e-14 -7.84095e-16 1.20737e-15 +335 1 5.87859 1.6796 5.87859 2.0664e-14 -1.14492e-15 2.01852e-14 +336 1 5.03879 2.51939 5.87859 3.60822e-16 -1.94289e-15 1.76248e-14 +337 1 6.71838 1.6796 5.03879 -3.08781e-15 -8.74301e-16 5.96745e-16 +338 1 7.55818 2.51939 5.03879 -2.22045e-16 -1.55431e-15 2.22045e-16 +339 1 7.55818 1.6796 5.87859 1.77636e-15 -9.08995e-16 2.19824e-14 +340 1 6.71838 2.51939 5.87859 -2.60902e-15 -1.94289e-15 2.10665e-14 +341 1 0 3.35919 5.03879 -8.88178e-15 1.06581e-14 4.44089e-16 +342 1 0.839798 4.19899 5.03879 2.77556e-15 -2.00534e-14 -9.71445e-16 +343 1 0.839798 3.35919 5.87859 2.66454e-15 1.26565e-14 2.26763e-14 +344 1 0 4.19899 5.87859 -7.10543e-15 -2.27318e-14 2.12053e-14 +345 1 1.6796 3.35919 5.03879 2.15106e-16 1.11022e-14 1.249e-15 +346 1 2.51939 4.19899 5.03879 -1.61676e-15 -2.07542e-14 8.32667e-17 +347 1 2.51939 3.35919 5.87859 -1.34615e-15 1.1921e-14 2.25445e-14 +348 1 1.6796 4.19899 5.87859 -8.74301e-16 -2.1684e-14 1.93387e-14 +349 1 3.35919 3.35919 5.03879 1.08247e-14 1.05055e-14 6.245e-16 +350 1 4.19899 4.19899 5.03879 -2.08722e-14 -2.192e-14 5.55112e-16 +351 1 4.19899 3.35919 5.87859 -2.34326e-14 9.83241e-15 2.01436e-14 +352 1 3.35919 4.19899 5.87859 9.61037e-15 -2.29053e-14 2.15591e-14 +353 1 5.03879 3.35919 5.03879 6.31439e-16 6.7446e-15 5.41234e-16 +354 1 5.87859 4.19899 5.03879 1.91375e-14 -2.03101e-14 2.498e-16 +355 1 5.87859 3.35919 5.87859 2.14412e-14 1.00198e-14 2.06293e-14 +356 1 5.03879 4.19899 5.87859 -2.01228e-16 -2.06224e-14 1.59386e-14 +357 1 6.71838 3.35919 5.03879 -3.02536e-15 9.69363e-15 4.85723e-17 +358 1 7.55818 4.19899 5.03879 -8.88178e-16 -2.28706e-14 -3.33067e-16 +359 1 7.55818 3.35919 5.87859 4.44089e-16 1.11855e-14 2.30926e-14 +360 1 6.71838 4.19899 5.87859 -3.44169e-15 -2.34396e-14 2.11914e-14 +361 1 0 5.03879 5.03879 -3.9968e-15 -6.66134e-16 4.44089e-16 +362 1 0.839798 5.87859 5.03879 2.66454e-15 1.93595e-14 5.55112e-16 +363 1 0.839798 5.03879 5.87859 3.10862e-15 -4.02456e-16 2.03726e-14 +364 1 0 5.87859 5.87859 -5.32907e-15 2.18159e-14 2.27596e-14 +365 1 1.6796 5.03879 5.03879 2.77556e-17 4.16334e-17 1.3739e-15 +366 1 2.51939 5.87859 5.03879 -1.56125e-15 1.82285e-14 1.76248e-15 +367 1 2.51939 5.03879 5.87859 -2.04003e-15 -1.1241e-15 1.95052e-14 +368 1 1.6796 5.87859 5.87859 2.08167e-17 2.11636e-14 2.05252e-14 +369 1 3.35919 5.03879 5.03879 8.17402e-15 3.40006e-16 3.33067e-16 +370 1 4.19899 5.87859 5.03879 -2.08653e-14 1.81868e-14 3.26128e-16 +371 1 4.19899 5.03879 5.87859 -2.05391e-14 -2.28983e-16 1.85199e-14 +372 1 3.35919 5.87859 5.87859 1.02834e-14 2.14967e-14 2.09693e-14 +373 1 5.03879 5.03879 5.03879 2.35922e-16 2.498e-16 -1.30451e-15 +374 1 5.87859 5.87859 5.03879 1.90889e-14 1.87003e-14 -2.70617e-16 +375 1 5.87859 5.03879 5.87859 1.91305e-14 8.74301e-16 1.98105e-14 +376 1 5.03879 5.87859 5.87859 1.38778e-17 1.92832e-14 1.88183e-14 +377 1 6.71838 5.03879 5.03879 -3.45557e-15 -3.05311e-16 1.51962e-15 +378 1 7.55818 5.87859 5.03879 -4.44089e-16 2.08722e-14 1.66533e-16 +379 1 7.55818 5.03879 5.87859 -1.33227e-15 5.55112e-16 2.08722e-14 +380 1 6.71838 5.87859 5.87859 -3.33067e-15 2.20102e-14 2.08999e-14 +381 1 0 6.71838 5.03879 -7.54952e-15 -4.44089e-15 8.88178e-16 +382 1 0.839798 7.55818 5.03879 2.33147e-15 4.71845e-16 9.15934e-16 +383 1 0.839798 6.71838 5.87859 2.88658e-15 -2.27596e-15 2.23016e-14 +384 1 0 7.55818 5.87859 -6.21725e-15 -2.22045e-16 2.31482e-14 +385 1 1.6796 6.71838 5.03879 -1.38778e-17 -2.86576e-15 1.27676e-15 +386 1 2.51939 7.55818 5.03879 -1.51268e-15 -8.32667e-16 6.66134e-16 +387 1 2.51939 6.71838 5.87859 -1.32533e-15 -2.27596e-15 2.22322e-14 +388 1 1.6796 7.55818 5.87859 -2.498e-16 1.77636e-15 2.13163e-14 +389 1 3.35919 6.71838 5.03879 1.05402e-14 -3.47639e-15 2.19963e-15 +390 1 4.19899 7.55818 5.03879 -2.27665e-14 -1.44329e-15 8.32667e-16 +391 1 4.19899 6.71838 5.87859 -2.39184e-14 -2.94209e-15 2.11775e-14 +392 1 3.35919 7.55818 5.87859 1.08802e-14 1.55431e-15 2.28706e-14 +393 1 5.03879 6.71838 5.03879 -7.63278e-17 -4.04538e-15 1.38778e-17 +394 1 5.87859 7.55818 5.03879 2.10457e-14 -7.21645e-16 7.21645e-16 +395 1 5.87859 6.71838 5.87859 2.31065e-14 -3.10862e-15 2.18714e-14 +396 1 5.03879 7.55818 5.87859 1.38778e-17 -4.44089e-16 2.08722e-14 +397 1 6.71838 6.71838 5.03879 -2.76168e-15 -2.74086e-15 -3.88578e-16 +398 1 7.55818 7.55818 5.03879 0 0 -6.66134e-16 +399 1 7.55818 6.71838 5.87859 0 -2.94209e-15 2.39808e-14 +400 1 6.71838 7.55818 5.87859 -3.16414e-15 7.77156e-16 2.42029e-14 +401 1 0 0 6.71838 -1.06581e-14 -1.04361e-14 -3.77476e-15 +402 1 0.839798 0.839798 6.71838 2.66454e-15 2.67841e-15 -2.72005e-15 +403 1 0.839798 0 7.55818 2.55351e-15 -9.70057e-15 1.05471e-15 +404 1 0 0.839798 7.55818 -8.88178e-15 2.66454e-15 4.44089e-16 +405 1 1.6796 0 6.71838 2.08167e-16 -7.99361e-15 -2.44249e-15 +406 1 2.51939 0.839798 6.71838 -1.8735e-15 2.77556e-15 -2.72005e-15 +407 1 2.51939 0 7.55818 -1.56819e-15 -8.88178e-15 0 +408 1 1.6796 0.839798 7.55818 -1.11022e-16 2.66454e-15 1.55431e-15 +409 1 3.35919 0 6.71838 1.26288e-14 -7.10543e-15 -2.88658e-15 +410 1 4.19899 0.839798 6.71838 -2.40641e-14 2.66454e-15 -4.69069e-15 +411 1 4.19899 0 7.55818 -2.43069e-14 -7.99361e-15 -4.44089e-16 +412 1 3.35919 0.839798 7.55818 1.38223e-14 2.66454e-15 1.33227e-15 +413 1 5.03879 0 6.71838 2.22045e-16 -6.21725e-15 -3.10862e-15 +414 1 5.87859 0.839798 6.71838 2.22183e-14 2.55351e-15 -1.4988e-15 +415 1 5.87859 0 7.55818 2.35922e-14 -6.21725e-15 -8.88178e-16 +416 1 5.03879 0.839798 7.55818 -4.71845e-16 2.55351e-15 -2.77556e-17 +417 1 6.71838 0 6.71838 -3.38618e-15 -6.99441e-15 -3.94129e-15 +418 1 7.55818 0.839798 6.71838 -1.16573e-15 2.60902e-15 -3.10862e-15 +419 1 7.55818 0 7.55818 -4.44089e-16 -8.65974e-15 -8.88178e-16 +420 1 6.71838 0.839798 7.55818 -2.27596e-15 2.45637e-15 0 +421 1 0 1.6796 6.71838 -1.02141e-14 -4.44089e-16 -3.33067e-15 +422 1 0.839798 2.51939 6.71838 2.77556e-15 -4.996e-16 -3.05311e-15 +423 1 0.839798 1.6796 7.55818 2.66454e-15 1.11022e-16 -1.66533e-16 +424 1 0 2.51939 7.55818 -7.99361e-15 -1.76248e-15 -2.22045e-16 +425 1 1.6796 1.6796 6.71838 2.08167e-16 -7.63278e-16 -2.31759e-15 +426 1 2.51939 2.51939 6.71838 -1.38778e-15 -9.99201e-16 -2.73392e-15 +427 1 2.51939 1.6796 7.55818 -1.47105e-15 5.55112e-17 7.14706e-16 +428 1 1.6796 2.51939 7.55818 -3.33067e-16 -2.06779e-15 -1.45717e-16 +429 1 3.35919 1.6796 6.71838 1.30312e-14 -6.93889e-18 -2.52576e-15 +430 1 4.19899 2.51939 6.71838 -2.37796e-14 -2.35922e-15 -4.35069e-15 +431 1 4.19899 1.6796 7.55818 -2.36061e-14 4.64906e-16 -6.45317e-16 +432 1 3.35919 2.51939 7.55818 1.29549e-14 -8.60423e-16 -1.20043e-15 +433 1 5.03879 1.6796 6.71838 0 -5.68989e-16 -2.42861e-15 +434 1 5.87859 2.51939 6.71838 2.20657e-14 -1.10328e-15 -2.7478e-15 +435 1 5.87859 1.6796 7.55818 2.22045e-14 -6.245e-16 5.20417e-16 +436 1 5.03879 2.51939 7.55818 1.38778e-16 -1.83187e-15 -8.46545e-16 +437 1 6.71838 1.6796 6.71838 -2.32453e-15 -5.06539e-16 -2.59515e-15 +438 1 7.55818 2.51939 6.71838 -2.22045e-16 -1.9984e-15 -3.4972e-15 +439 1 7.55818 1.6796 7.55818 6.66134e-16 5.55112e-17 -1.33227e-15 +440 1 6.71838 2.51939 7.55818 -2.83107e-15 -2.06779e-15 -6.66134e-16 +441 1 0 3.35919 6.71838 -1.11022e-14 1.31006e-14 -2.88658e-15 +442 1 0.839798 4.19899 6.71838 2.66454e-15 -2.28359e-14 -4.46865e-15 +443 1 0.839798 3.35919 7.55818 2.55351e-15 1.38362e-14 5.55112e-17 +444 1 0 4.19899 7.55818 -7.99361e-15 -2.44457e-14 -8.88178e-16 +445 1 1.6796 3.35919 6.71838 2.22045e-16 1.20598e-14 -2.05391e-15 +446 1 2.51939 4.19899 6.71838 -1.09635e-15 -2.38767e-14 -4.46171e-15 +447 1 2.51939 3.35919 7.55818 -1.92901e-15 1.40235e-14 -9.02056e-17 +448 1 1.6796 4.19899 7.55818 4.16334e-17 -2.43833e-14 -1.54737e-15 +449 1 3.35919 3.35919 6.71838 1.28716e-14 1.13104e-14 -2.16493e-15 +450 1 4.19899 4.19899 6.71838 -2.44943e-14 -2.37588e-14 -4.78784e-15 +451 1 4.19899 3.35919 7.55818 -2.42584e-14 1.09426e-14 6.38378e-16 +452 1 3.35919 4.19899 7.55818 1.13798e-14 -2.49245e-14 -1.59595e-15 +453 1 5.03879 3.35919 6.71838 -2.35922e-16 8.98587e-15 -1.98452e-15 +454 1 5.87859 4.19899 6.71838 2.29469e-14 -2.33771e-14 -3.1572e-15 +455 1 5.87859 3.35919 7.55818 2.34951e-14 1.07414e-14 1.80411e-15 +456 1 5.03879 4.19899 7.55818 4.16334e-17 -2.19547e-14 -1.42941e-15 +457 1 6.71838 3.35919 6.71838 -3.13638e-15 1.12688e-14 -2.26208e-15 +458 1 7.55818 4.19899 6.71838 2.22045e-16 -2.59792e-14 -1.38778e-15 +459 1 7.55818 3.35919 7.55818 0 1.28855e-14 -8.88178e-16 +460 1 6.71838 4.19899 7.55818 -2.66454e-15 -2.52992e-14 -1.05471e-15 +461 1 0 5.03879 6.71838 -6.21725e-15 2.22045e-16 -2.22045e-15 +462 1 0.839798 5.87859 6.71838 2.55351e-15 2.25375e-14 -2.38698e-15 +463 1 0.839798 5.03879 7.55818 2.66454e-15 1.38778e-17 6.38378e-16 +464 1 0 5.87859 7.55818 -6.21725e-15 2.3842e-14 -2.22045e-16 +465 1 1.6796 5.03879 6.71838 4.44089e-16 -1.17961e-15 -2.20657e-15 +466 1 2.51939 5.87859 6.71838 -1.51962e-15 2.23849e-14 -2.19269e-15 +467 1 2.51939 5.03879 7.55818 -1.90126e-15 -3.26128e-16 6.38378e-16 +468 1 1.6796 5.87859 7.55818 -6.93889e-17 2.2593e-14 1.76942e-15 +469 1 3.35919 5.03879 6.71838 1.02557e-14 -1.31839e-15 -2.20657e-15 +470 1 4.19899 5.87859 6.71838 -2.37102e-14 2.16563e-14 -1.60288e-15 +471 1 4.19899 5.03879 7.55818 -2.25375e-14 1.38778e-17 -7.63278e-16 +472 1 3.35919 5.87859 7.55818 1.15047e-14 2.3162e-14 8.32667e-16 +473 1 5.03879 5.03879 6.71838 -2.28983e-16 -1.00614e-15 -3.27516e-15 +474 1 5.87859 5.87859 6.71838 2.35922e-14 2.19824e-14 -1.88738e-15 +475 1 5.87859 5.03879 7.55818 2.15383e-14 -2.63678e-16 7.70217e-16 +476 1 5.03879 5.87859 7.55818 1.38778e-17 2.13718e-14 3.26128e-16 +477 1 6.71838 5.03879 6.71838 -3.48332e-15 -9.71445e-16 -1.83187e-15 +478 1 7.55818 5.87859 6.71838 -2.22045e-16 2.39808e-14 -3.38618e-15 +479 1 7.55818 5.03879 7.55818 -1.33227e-15 -1.17961e-16 -6.66134e-16 +480 1 6.71838 5.87859 7.55818 -2.83107e-15 2.47372e-14 -3.88578e-16 +481 1 0 6.71838 6.71838 -9.32587e-15 -3.9968e-15 -2.88658e-15 +482 1 0.839798 7.55818 6.71838 2.44249e-15 0 -2.94209e-15 +483 1 0.839798 6.71838 7.55818 2.55351e-15 -3.15026e-15 -3.33067e-16 +484 1 0 7.55818 7.55818 -8.88178e-15 0 -2.22045e-16 +485 1 1.6796 6.71838 6.71838 2.15106e-16 -3.04617e-15 -3.05311e-15 +486 1 2.51939 7.55818 6.71838 -1.54043e-15 -5.55112e-16 -2.72005e-15 +487 1 2.51939 6.71838 7.55818 -2.08167e-15 -2.55351e-15 -2.77556e-17 +488 1 1.6796 7.55818 7.55818 2.77556e-17 -6.66134e-16 -1.11022e-15 +489 1 3.35919 6.71838 6.71838 1.22749e-14 -3.60129e-15 -2.27596e-15 +490 1 4.19899 7.55818 6.71838 -2.57433e-14 -6.66134e-16 -3.27516e-15 +491 1 4.19899 6.71838 7.55818 -2.58682e-14 -3.55271e-15 4.44089e-16 +492 1 3.35919 7.55818 7.55818 1.25316e-14 0 -4.44089e-16 +493 1 5.03879 6.71838 6.71838 0 -4.14252e-15 -3.19189e-15 +494 1 5.87859 7.55818 6.71838 2.47719e-14 -4.996e-16 -2.66454e-15 +495 1 5.87859 6.71838 7.55818 2.47163e-14 -2.66454e-15 -5.55112e-17 +496 1 5.03879 7.55818 7.55818 5.55112e-17 -2.22045e-16 6.66134e-16 +497 1 6.71838 6.71838 6.71838 -2.58127e-15 -3.18495e-15 -3.03924e-15 +498 1 7.55818 7.55818 6.71838 -2.22045e-16 0 -3.05311e-15 +499 1 7.55818 6.71838 7.55818 0 -2.69229e-15 -1.33227e-15 +500 1 6.71838 7.55818 7.55818 -2.66454e-15 9.02056e-16 -2.22045e-16 +ITEM: TIMESTEP +100 +ITEM: NUMBER OF ATOMS +500 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 0.123071 8.38872 8.3161 -13.5034 12.7208 4.27264 +2 1 0.832093 0.789482 0.0260634 11.6405 -9.02308 5.27054 +3 1 0.829348 8.32295 0.847054 0.253685 2.42198 0.190462 +4 1 0.167866 0.883683 1.1203 3.78838 -17.5987 -23.5446 +5 1 1.84325 0.268983 0.0506746 -34.1939 -23.1747 -16.5239 +6 1 2.48966 1.02521 0.0150167 17.3336 21.4777 -8.17686 +7 1 2.69085 0.133161 0.584204 54.6376 -37.2919 -8.47938 +8 1 2.03129 0.673907 1.00581 -42.9604 37.8091 32.6152 +9 1 3.4644 0.135395 8.22513 6.66121 1.25052 1.24977 +10 1 4.03955 1.11148 8.14659 12.0412 -8.97859 6.48992 +11 1 4.19379 0.0448744 0.829139 -7.8302 -27.8417 -6.76025 +12 1 3.64841 0.913699 0.700293 -19.72 -1.80986 -1.25088 +13 1 4.95468 8.24864 0.0754237 1.84477 -0.530278 -6.08608 +14 1 5.56087 0.715896 7.89459 8.56765 -1.46102 11.0915 +15 1 5.88623 0.0411411 0.556827 1.26181 -8.5789 -11.0866 +16 1 4.92937 0.724638 0.812217 17.273 10.8714 -8.85433 +17 1 6.72739 8.38085 8.13417 -35.3805 -5.9515 28.6252 +18 1 7.72548 0.788736 0.0488514 2.00593 -21.6326 -29.6842 +19 1 7.72508 8.25409 0.930095 1.50566 4.42937 -3.62071 +20 1 6.80396 0.557293 0.840198 23.1381 -17.3706 0.134541 +21 1 0.229449 1.60533 8.39298 -14.4977 16.7962 1.07689 +22 1 0.832071 2.6454 0.0244343 3.40253 -11.2938 10.3532 +23 1 1.17502 1.54184 1.17348 -25.8959 -2.9461 -24.9151 +24 1 0.259004 2.30396 1.08005 -0.921709 -4.92947 -4.61717 +25 1 1.52612 1.69846 0.0790119 2.24081 -1.66091 4.11232 +26 1 2.32335 2.59169 0.0356063 -1.33192 -7.27448 11.4357 +27 1 2.47613 1.68798 0.866847 -6.11708 -1.09078 12.1273 +28 1 1.75964 2.46963 1.02161 -10.4242 6.62214 -9.26339 +29 1 3.18899 1.91192 0.152422 12.8306 -10.0239 -26.2805 +30 1 4.16606 2.56561 0.31819 6.19268 17.1047 -29.5908 +31 1 4.20679 1.77492 0.904599 6.39419 -20.2587 16.143 +32 1 3.29457 2.54016 0.942536 8.4707 7.62624 9.38928 +33 1 5.08962 1.70142 0.228194 -1.96985 -10.7878 -18.1781 +34 1 5.8401 2.50153 8.17919 2.2116 -4.35098 8.5453 +35 1 6.13077 1.14332 0.361455 -13.4767 12.4455 -5.6398 +36 1 5.21187 2.29543 1.04708 -21.2445 17.0192 -2.44157 +37 1 7.1904 2.12537 8.11861 -26.262 1.63538 -8.89421 +38 1 7.82272 2.3769 0.452291 6.46918 9.92036 10.2415 +39 1 7.65568 1.36632 0.837818 -8.61574 34.9087 15.0511 +40 1 6.63096 2.29607 0.833592 -3.02945 -9.31899 -38.2195 +41 1 0.0701224 3.26957 0.347776 -7.76983 -4.00147 -12.0182 +42 1 0.634247 4.2146 8.13102 5.69069 28.6823 19.9973 +43 1 0.89062 3.25892 1.01274 -8.90571 5.17288 9.1951 +44 1 8.35578 4.21333 0.756755 0.0651816 10.3427 6.16366 +45 1 1.59376 3.50824 0.337522 12.8481 -18.5931 -31.178 +46 1 2.63362 4.08805 -0.0117409 -13.6881 -31.4545 31.8377 +47 1 2.64545 3.44217 0.972182 1.32962 4.76915 -6.91838 +48 1 1.77157 4.31331 0.893182 6.24463 15.8362 30.2465 +49 1 3.30506 3.15734 -0.00281637 -4.50664 8.90697 10.0795 +50 1 4.20121 3.98351 8.24532 14.9588 -4.89636 4.16185 +51 1 4.14049 3.34001 1.03567 7.31744 -35.2634 -0.734077 +52 1 3.55633 4.09497 0.714486 -22.5487 2.59697 3.44603 +53 1 5.00488 3.2958 8.40544 4.72004 -3.7586 -0.0676635 +54 1 6.02419 4.38739 8.28472 2.63675 -3.85348 -7.36203 +55 1 5.82125 3.13701 0.812331 3.285 1.60137 -0.83853 +56 1 4.81191 4.1205 0.886429 26.0514 -19.7571 -10.6482 +57 1 6.37904 3.38462 8.29958 8.77859 5.40588 1.21659 +58 1 7.16155 4.27433 8.23885 -4.15514 -15.8519 20.8515 +59 1 7.46381 3.5222 0.62725 -6.50801 1.62892 11.1525 +60 1 6.52496 4.16064 0.796816 7.21171 -6.93074 -7.48151 +61 1 8.21062 5.02405 8.32529 2.06274 -1.43255 -7.09188 +62 1 0.856242 5.68027 8.15143 -7.33544 -9.25849 21.6195 +63 1 0.668812 5.05722 1.0253 10.4106 -11.6037 -16.0599 +64 1 0.100757 5.9519 0.987463 -8.02818 6.7945 -7.41084 +65 1 1.67634 4.74298 8.35528 -7.26839 1.52359 -11.0387 +66 1 2.38848 5.51086 0.107164 2.54651 6.03927 1.46743 +67 1 2.70757 4.93813 1.01132 -4.75577 -9.71554 1.13089 +68 1 1.3925 5.83052 0.707681 -1.14437 -6.44566 7.34655 +69 1 3.45574 4.66587 8.23291 4.73605 39.4767 5.5614 +70 1 4.43743 5.80479 0.164115 -6.64024 0.386075 1.78009 +71 1 4.2065 4.90669 0.741814 -23.5797 23.1046 -22.8102 +72 1 3.32112 5.74269 0.715517 7.3169 4.77905 3.84994 +73 1 5.16076 4.9557 8.31038 -10.6163 5.08193 1.86037 +74 1 5.94307 5.96922 0.174598 0.307423 -9.87615 -0.075099 +75 1 5.67998 4.99641 0.866467 -3.37502 0.387608 -1.06988 +76 1 5.10533 6.15466 0.974945 -0.684733 -17.9465 -18.2172 +77 1 6.66954 5.212 0.215572 3.55269 -19.7927 -9.30717 +78 1 7.63194 6.03007 0.0625005 22.452 -11.4487 -13.3981 +79 1 7.77987 5.15692 0.880268 -13.4303 3.64316 1.97115 +80 1 6.9443 6.00859 0.774386 -22.1564 -21.0173 44.3085 +81 1 0.211543 6.60981 0.114883 -6.22763 -3.96979 4.85396 +82 1 0.828363 7.71074 8.05758 6.57912 -12.175 1.18202 +83 1 0.8511 6.85772 1.00145 14.3344 -16.9148 6.86093 +84 1 0.108182 7.491 0.729711 -16.3275 13.3125 -2.16192 +85 1 1.32651 6.53754 8.31267 17.3977 32.295 0.779922 +86 1 2.45313 7.32438 0.161863 4.38219 8.94585 -15.0057 +87 1 2.22206 6.5101 0.817864 2.61276 2.64125 -0.96007 +88 1 1.71157 7.54558 0.836721 -10.8648 3.37169 8.49449 +89 1 3.33137 6.74361 0.251121 4.01956 -5.07144 -3.19134 +90 1 4.31785 7.3164 0.250439 -2.62105 14.0423 -19.3334 +91 1 4.11403 6.69271 1.01148 -3.23605 5.58393 9.21791 +92 1 3.25046 7.65301 0.863299 7.69366 -3.67127 3.31805 +93 1 5.15822 6.61638 8.39412 -15.5898 18.5262 -4.77657 +94 1 5.88176 7.47131 8.35911 1.25772 40.9097 -41.218 +95 1 5.8589 6.89406 0.716878 17.4729 -36.9167 60.1945 +96 1 5.1317 7.5805 0.887324 -15.4398 8.72154 0.622041 +97 1 6.7242 6.72984 0.126171 2.95649 13.978 -28.6002 +98 1 7.71076 7.70275 8.27387 -25.252 1.96163 47.723 +99 1 7.67756 6.66145 0.969756 13.165 19.6736 4.48693 +100 1 6.86126 7.61056 0.694229 -2.98636 3.99324 3.02821 +101 1 8.36607 8.27958 1.86716 -0.17632 -3.19355 -10.789 +102 1 0.956051 0.693329 1.82901 -1.1092 0.489919 9.03263 +103 1 0.677954 8.19357 2.69404 9.64796 -1.44576 4.92708 +104 1 8.40822 0.658358 2.57043 0.358989 35.1247 -30.1625 +105 1 1.59709 8.27384 1.6579 -3.48424 8.95256 3.83776 +106 1 2.60262 0.937274 1.91114 -6.85695 -44.4167 -8.16487 +107 1 2.77964 8.33738 2.42411 -9.97653 17.8509 12.2111 +108 1 1.80103 0.545423 2.70436 3.05773 -0.374817 -3.43865 +109 1 3.48439 0.0645578 1.59153 -12.2456 1.16104 1.511 +110 1 4.22306 0.908637 1.62246 8.21176 3.032 -1.28199 +111 1 4.10829 0.251535 2.42791 -11.6297 -7.60593 -5.50766 +112 1 3.3006 0.854758 2.76304 -19.992 -17.3193 -31.4497 +113 1 4.89013 8.37666 1.691 47.9119 57.0599 0.585594 +114 1 5.94061 0.477826 1.48406 -3.07899 1.88699 12.3275 +115 1 5.88048 0.35971 2.56281 -4.35157 -20.3865 4.17854 +116 1 4.9283 1.00358 2.55425 0.721177 -5.70224 -8.52683 +117 1 6.83323 8.16485 1.66012 -9.63203 10.6138 -6.53177 +118 1 7.60236 0.72315 1.6205 1.19764 -13.0731 15.2148 +119 1 7.46261 8.34785 2.50942 4.27014 7.86644 3.21827 +120 1 6.98477 1.01167 2.43863 -2.7077 -3.72405 10.5475 +121 1 0.201795 1.49879 1.91201 12.0746 15.4759 7.55997 +122 1 0.970651 2.5763 1.77546 9.10281 -9.21672 19.206 +123 1 1.00278 1.70354 2.64935 -4.86832 -2.32063 -12.0578 +124 1 0.220174 2.4694 2.59226 -6.06395 2.41662 -4.31274 +125 1 1.87438 1.66139 1.85364 0.0891009 8.26815 7.54904 +126 1 2.5634 2.61259 1.66324 -1.39613 -9.56029 15.7565 +127 1 2.67373 1.74855 2.48368 16.2507 26.3662 25.5413 +128 1 1.81271 2.51993 2.48462 -12.4635 -12.9481 6.24626 +129 1 3.34642 1.5174 1.55361 6.72778 19.0825 -4.097 +130 1 4.08393 2.3973 1.7811 -4.91883 6.9472 -7.45962 +131 1 3.95017 1.57032 2.47783 9.96822 8.42852 -4.63348 +132 1 3.54843 2.54548 2.73936 0.891724 -11.4891 -8.75214 +133 1 5.35058 1.38537 1.51823 -3.50731 -2.89085 5.66595 +134 1 6.023 2.29204 1.65213 -4.43652 -0.464129 22.1024 +135 1 5.94747 1.35093 2.39209 2.54676 22.9646 2.61125 +136 1 4.92685 2.18916 2.37644 10.4243 -2.12633 1.01963 +137 1 6.61187 1.36453 1.49274 0.221959 8.29598 -0.620687 +138 1 7.32473 2.28685 1.57865 28.4734 -28.9459 -8.73783 +139 1 7.72873 1.81047 2.35176 -1.00775 -9.06934 31.0045 +140 1 6.61584 2.21437 2.52479 7.01251 0.0677084 2.80218 +141 1 8.39022 3.27891 1.73012 3.49525 -5.17929 -4.65996 +142 1 0.854964 4.19407 1.69788 1.56946 -2.00702 1.06174 +143 1 0.997978 3.23715 2.67504 2.30643 5.8223 1.06858 +144 1 7.97382 3.9138 2.48815 10.0732 9.91828 -12.5132 +145 1 1.83784 3.47408 1.69517 -12.404 -3.21409 -2.66267 +146 1 2.61842 4.21682 1.90008 2.14748 0.059531 -3.785 +147 1 2.48603 3.26502 2.5249 16.8304 14.9965 0.171158 +148 1 1.68761 4.23907 2.52806 -1.01396 -4.72261 -0.795752 +149 1 3.40602 3.2813 1.85914 -16.1626 0.355927 -8.83409 +150 1 4.09906 4.10307 1.70079 5.35563 8.08157 -4.08084 +151 1 4.20252 3.30769 2.50236 16.5461 8.94662 0.427258 +152 1 3.52577 4.20363 2.52362 -12.9682 0.481811 23.6133 +153 1 5.11847 3.18122 1.75203 -10.5302 -5.4337 -0.263304 +154 1 5.84661 3.9209 1.56262 -0.517958 8.86577 8.63788 +155 1 5.86922 3.05768 2.56393 3.07392 -0.105811 -3.05554 +156 1 4.80787 4.20147 2.51562 -15.5306 -18.6016 6.98719 +157 1 6.75594 3.06184 1.51831 -23.9843 53.9056 5.35996 +158 1 7.37411 4.33015 1.50837 10.7935 -8.89263 2.38858 +159 1 7.49772 2.90887 2.46868 -6.63254 10.1343 -14.9923 +160 1 6.70853 3.86113 2.32478 1.28299 1.19192 -0.76331 +161 1 8.35107 4.97447 1.76826 -6.01727 -4.60108 12.0065 +162 1 0.812206 5.83167 1.72433 7.83055 6.4827 17.8655 +163 1 0.780537 4.91988 2.60048 6.34607 -5.57446 -13.8552 +164 1 8.22728 5.818 2.44166 16.0462 -1.57715 15.6299 +165 1 1.69572 5.11642 1.80574 -4.96566 -14.135 -5.31489 +166 1 2.43043 5.85297 1.63568 5.29915 -1.62077 5.85546 +167 1 2.57792 5.02783 2.65315 -4.52746 -19.2236 -8.91777 +168 1 1.53526 5.79854 2.60003 3.8059 -10.2938 -9.84612 +169 1 3.51815 5.02648 1.76532 -11.6984 -21.692 -35.1665 +170 1 4.20879 5.78771 1.44267 -4.45704 -9.43328 11.2812 +171 1 4.17986 5.08228 2.52246 26.037 -4.72131 -0.0794421 +172 1 3.28564 5.71935 2.4374 15.7539 34.931 2.27384 +173 1 4.77269 4.90482 1.56605 20.4715 8.53759 27.1606 +174 1 6.0822 5.98003 1.39493 -10.1112 -7.66907 2.17662 +175 1 5.55864 4.81486 2.32198 32.4427 -4.71792 -40.0608 +176 1 5.42317 5.8389 2.32907 -1.32862 11.7729 0.869635 +177 1 6.58632 5.00994 1.4228 1.50987 11.9718 7.91199 +178 1 7.40728 5.76017 1.85143 -17.7756 -1.69935 -20.7445 +179 1 7.43483 4.90248 2.50406 4.81208 -4.17509 -3.00519 +180 1 6.49032 6.25339 2.53785 -9.86939 -13.1275 -11.226 +181 1 8.38687 6.70803 1.84686 8.51598 2.67685 -7.76441 +182 1 0.82672 7.5809 1.8586 -8.65199 -8.55201 -6.88257 +183 1 0.798368 6.66179 2.58415 -9.89719 -0.151349 -9.60426 +184 1 8.09266 7.50342 2.71078 14.8523 -0.33865 -5.72558 +185 1 1.67226 6.92941 1.90638 3.68667 -6.81729 -3.8166 +186 1 2.44977 7.72472 1.67328 13.6121 -19.3583 -10.8323 +187 1 2.6005 7.00136 2.53195 -4.75836 -8.709 1.95523 +188 1 1.74762 7.69197 2.71318 -2.53247 4.05033 -0.19863 +189 1 3.12318 6.68472 1.56494 -10.4586 3.85751 -11.4518 +190 1 4.29009 7.65387 1.60791 -51.7416 -54.1223 -14.9832 +191 1 3.94907 6.70085 2.16915 18.0446 -8.10905 7.08373 +192 1 3.47208 7.58339 2.49347 14.5465 5.92984 -2.02778 +193 1 5.12563 6.77282 1.76131 -9.48863 14.4825 6.97263 +194 1 5.83539 7.62987 1.64588 8.72191 3.82062 7.16953 +195 1 5.76423 6.96836 2.55864 -5.64345 11.6948 11.2338 +196 1 4.77822 7.71547 2.51809 6.21883 -11.3323 9.13654 +197 1 6.63559 6.81418 1.65333 9.11964 14.1494 -8.37133 +198 1 7.61434 7.47455 1.72558 2.40335 0.461228 -6.0911 +199 1 7.4792 6.66861 2.39873 -2.80551 0.930229 8.6336 +200 1 6.74988 7.49855 2.51532 0.27108 -2.11137 5.23264 +201 1 8.33028 0.11458 3.36279 -16.5826 -29.3888 39.8482 +202 1 0.924222 0.663074 3.34599 -4.22349 8.71948 1.26084 +203 1 0.761543 8.18959 3.97906 2.12091 4.50677 4.24971 +204 1 8.33433 0.813163 4.20564 6.5007 1.52148 -0.192127 +205 1 1.76574 0.0375621 3.77071 17.3013 -16.3871 -16.9245 +206 1 2.61977 0.818953 3.52119 -23.2651 -2.55324 12.2346 +207 1 2.77562 0.0652161 4.44741 -11.8421 6.13727 -13.8855 +208 1 1.49199 0.761034 4.41597 -5.10709 15.0925 14.5126 +209 1 3.2179 8.34804 3.44668 5.27936 -7.50847 -1.90568 +210 1 3.9439 0.797129 3.52456 17.3728 2.18733 11.5361 +211 1 4.23279 0.116688 4.32559 -2.42219 -2.56552 -2.26636 +212 1 3.32804 0.997948 4.36883 1.65433 -5.54648 3.47818 +213 1 4.71275 0.120112 3.21294 23.362 4.56383 23.3458 +214 1 5.81093 1.04185 3.50642 -3.03834 -26.4106 -17.8435 +215 1 5.68877 0.288558 4.20831 -1.41276 -13.7346 9.5471 +216 1 5.01865 1.1392 4.32627 0.968145 -3.23051 -6.43149 +217 1 6.64793 8.39618 3.24984 2.09632 -4.36032 3.69009 +218 1 7.5883 0.965027 3.40354 -4.44096 -3.20185 -1.58139 +219 1 7.46506 8.38162 4.26807 1.21074 2.40143 -20.8016 +220 1 6.68567 0.729309 4.05423 9.00491 -0.0257829 7.04417 +221 1 0.0217051 1.65067 3.33296 -0.896942 -12.0422 -1.44038 +222 1 0.778955 2.33585 3.53158 8.17696 34.6193 -17.2054 +223 1 0.812105 1.63712 4.22741 2.15493 -21.1842 9.58449 +224 1 8.36402 2.71734 4.23224 9.90405 -0.180735 2.89262 +225 1 1.64503 1.55583 3.44456 9.91651 -2.24847 10.5707 +226 1 2.72789 2.60115 3.33289 -22.1633 -6.4618 14.3253 +227 1 2.53285 1.75288 4.15927 -11.2604 4.59027 8.59695 +228 1 1.59486 2.51559 4.29587 -0.634079 -19.903 20.3392 +229 1 3.26158 1.6458 3.43181 16.9482 17.4067 -1.31054 +230 1 4.49124 2.67296 3.29881 0.516577 8.93567 6.85853 +231 1 4.12441 1.76399 4.16025 -12.4119 -16.9863 20.8263 +232 1 3.58648 2.62356 4.12513 -11.0948 -0.0880381 2.09248 +233 1 4.62064 1.66433 3.30411 17.3359 -14.3916 -7.7698 +234 1 5.72203 2.02067 3.4449 -2.49843 31.6335 -13.0426 +235 1 6.15135 1.60495 4.33133 -9.75959 4.02084 8.19224 +236 1 5.04088 2.23941 4.27882 30.2001 -2.39587 -19.7025 +237 1 6.91779 1.8813 3.52264 3.96777 -26.054 4.41687 +238 1 7.81771 2.53776 3.353 -2.77684 -3.41763 12.6677 +239 1 7.78069 1.81171 4.34601 -52.3825 1.07947 -51.791 +240 1 6.66141 2.49312 4.62997 -6.69802 -0.0628228 -12.7191 +241 1 0.122629 3.46604 3.3479 -1.26446 -22.7991 -11.2332 +242 1 0.85888 4.22824 3.46647 2.79502 3.87933 -3.60293 +243 1 0.937247 3.40088 4.29114 -12.1658 -1.27655 -7.25993 +244 1 8.30307 4.19021 4.02192 -7.37977 10.0618 19.4199 +245 1 1.73804 3.18337 3.5685 -15.8464 9.26468 -37.1326 +246 1 2.58615 4.05913 3.19953 0.360202 14.7294 -1.16411 +247 1 2.55925 3.4674 4.05471 16.7959 -2.51521 13.6147 +248 1 1.75131 4.20697 4.04231 3.51698 -5.56503 7.27084 +249 1 3.44857 3.37138 3.44602 9.39764 18.3315 -14.5187 +250 1 4.30487 4.37452 3.51867 -0.743412 -11.0963 -4.3924 +251 1 4.41614 3.34547 4.13696 17.6233 7.57534 -14.2893 +252 1 3.32801 4.25542 4.08286 6.07649 -1.13934 3.22429 +253 1 5.63651 3.09553 3.631 -4.7187 3.44811 6.48572 +254 1 5.99275 4.08946 3.17209 -2.06613 -3.23888 -8.73239 +255 1 6.47603 3.67609 4.18744 -9.24013 0.891239 -0.0265923 +256 1 5.32989 4.17403 4.01248 -3.14576 -0.648453 6.26049 +257 1 6.72457 2.86539 3.51605 -3.69406 17.3565 -4.96963 +258 1 7.32281 3.76777 3.25105 -10.2265 -1.63605 18.2335 +259 1 7.4303 3.25631 4.3358 5.44768 7.87627 -9.74689 +260 1 6.66407 4.65396 3.76405 -6.96361 -4.18223 2.73914 +261 1 8.26711 4.8857 3.17584 6.51218 -0.295316 -2.27808 +262 1 0.649285 5.74933 3.20979 -12.9544 -9.12523 -13.313 +263 1 1.01858 5.10915 4.40565 1.04387 0.402418 -2.70019 +264 1 0.0855082 5.80312 4.16158 -11.0199 -7.09759 8.81305 +265 1 1.78399 4.97143 3.32025 -23.7199 7.54456 -3.60592 +266 1 2.55969 5.96317 3.12483 -8.84523 11.7944 16.8138 +267 1 2.653 5.05017 3.85074 -4.37713 4.79953 16.9312 +268 1 2.04667 5.9581 4.23583 -12.9689 -9.50066 -2.67062 +269 1 3.52568 5.09169 3.32195 -1.60301 -3.74832 -0.530875 +270 1 4.17719 5.92991 3.13207 5.79449 2.84869 4.98978 +271 1 4.69237 5.20087 4.04914 -22.9168 0.480558 19.5714 +272 1 3.49623 5.87284 4.08872 -22.1914 -19.7939 -11.835 +273 1 5.22134 4.9979 3.22696 -11.435 -2.89555 -13.2152 +274 1 5.65705 6.11892 3.42751 2.78011 1.11701 -3.25891 +275 1 5.76121 5.22134 4.03501 7.67556 -2.59727 25.3068 +276 1 4.95772 6.04539 4.58052 58.0203 8.0254 -45.1554 +277 1 6.4538 5.11955 2.78748 -4.74406 7.07146 5.73728 +278 1 7.21538 5.95413 3.16364 10.7768 -10.9442 6.36207 +279 1 7.51809 5.20099 3.85697 17.9797 5.14787 9.68311 +280 1 6.63903 5.76912 4.06379 2.12496 12.0521 4.75162 +281 1 8.12324 6.45888 3.3557 6.09728 0.195353 -8.64393 +282 1 0.462088 7.19726 3.46792 19.553 -0.0547515 -15.4409 +283 1 0.957118 6.33073 3.94731 10.4711 20.6934 10.8557 +284 1 8.31788 7.62476 4.18946 -15.5996 1.5203 27.0435 +285 1 1.621 6.60508 3.20723 21.3874 20.2704 9.57573 +286 1 2.43565 7.40381 3.575 -2.23423 10.7661 -7.60718 +287 1 2.75508 6.70843 4.26783 9.69215 -9.86312 8.63304 +288 1 1.4194 7.32943 4.0782 6.712 1.12768 -13.3449 +289 1 3.55435 6.77984 3.25216 -11.0849 -3.43265 4.44657 +290 1 4.09983 7.6717 3.40332 0.775894 2.91256 6.51607 +291 1 4.08342 6.6168 4.34423 8.99422 27.9061 4.38721 +292 1 3.36001 7.55781 4.25663 44.0502 4.81661 -43.4399 +293 1 4.74991 6.77738 3.51304 4.59094 -3.55683 -10.177 +294 1 5.77556 7.6737 3.71378 -0.245399 -1.3978 -0.93703 +295 1 5.90589 6.74801 4.34426 -3.316 -4.25196 -0.216303 +296 1 4.8074 7.40991 4.34207 4.23627 19.8452 -2.32284 +297 1 6.58813 6.85169 3.45364 -7.67639 -5.27403 -11.3349 +298 1 7.50241 7.47925 3.56723 2.18816 13.5038 -24.0989 +299 1 7.40344 6.62065 4.10638 -2.8935 -4.19323 5.51308 +300 1 6.75843 7.5046 4.25149 -20.47 8.43665 16.7865 +301 1 8.33167 8.36145 4.9892 0.225809 34.2346 -31.8957 +302 1 0.576342 0.867151 5.40959 24.5697 -12.6304 -33.2572 +303 1 0.763006 0.00458111 6.00676 12.4506 6.43147 -2.11226 +304 1 8.26499 0.860176 6.08382 -7.17683 -4.07129 -51.5552 +305 1 1.81244 8.0383 4.87052 -5.76863 7.26347 -9.86755 +306 1 2.53533 1.09902 5.19234 -3.16803 0.678291 -2.97003 +307 1 2.78135 0.403413 6.40689 -26.816 9.12488 -11.3363 +308 1 1.58905 0.651353 5.66283 7.03419 0.981612 1.76622 +309 1 3.32058 0.106866 5.32447 -0.932856 13.5857 14.9154 +310 1 4.27557 0.92435 5.10725 -6.99093 5.63655 -6.45098 +311 1 4.28959 0.280237 5.95961 -30.2191 -30.0316 -14.6333 +312 1 3.38904 1.26869 5.835 20.8336 -7.28254 -13.6106 +313 1 5.00946 8.32617 5.09801 -7.438 6.03549 0.926349 +314 1 5.92216 0.863628 5.14574 -0.277075 -6.34381 -3.05305 +315 1 5.73427 0.0193827 5.90902 4.17974 0.428592 2.11829 +316 1 4.94752 0.963499 5.95092 36.9682 12.4342 8.28196 +317 1 6.68007 0.0753806 5.17719 -6.21888 -0.275929 -7.94036 +318 1 7.59475 0.718477 4.99 5.56935 4.26124 12.8688 +319 1 7.48253 8.3166 5.84711 10.9136 10.2783 15.4989 +320 1 6.8326 0.897437 5.9487 8.18452 -13.9005 5.8213 +321 1 0.0760609 1.64664 4.96296 26.1716 -2.70613 34.3225 +322 1 0.685552 2.56455 5.03633 12.0035 4.84556 -15.2829 +323 1 0.606729 1.82267 5.82598 7.27963 -3.46786 12.0617 +324 1 8.3293 2.58271 5.72712 2.9601 13.0212 32.1025 +325 1 1.39999 1.70565 5.12122 8.3487 -4.09076 2.04128 +326 1 2.73507 2.85653 4.90403 -0.345779 -0.804973 -4.73226 +327 1 2.41817 2.24309 5.70209 1.42091 -4.90412 -0.964796 +328 1 1.38108 2.54746 5.86585 12.2906 4.17611 0.525771 +329 1 3.33731 1.91289 4.90293 0.0185627 0.794978 8.4213 +330 1 4.3973 2.60866 4.92615 -15.1153 4.67891 22.5372 +331 1 4.2225 2.0218 5.81106 18.0418 -47.4422 -19.4137 +332 1 3.4994 2.65878 5.66207 -24.6152 28.1329 2.91513 +333 1 5.20081 1.64695 5.25699 -1.61968 25.0354 -10.6249 +334 1 5.90254 2.56674 5.38347 4.70787 3.18361 -12.95 +335 1 6.08989 1.61464 5.89214 -10.9271 -1.55847 2.77666 +336 1 5.02754 2.69198 5.87273 -13.869 2.1523 1.52243 +337 1 6.90208 1.46146 5.07178 -10.118 15.4867 -8.4201 +338 1 7.58477 2.54489 5.07036 0.223295 2.60985 -3.71518 +339 1 7.69807 1.70404 5.74305 2.65747 -7.01835 5.70621 +340 1 6.83671 2.31874 5.77518 8.75763 5.85965 2.81961 +341 1 8.33535 3.4475 5.0472 4.04483 5.65066 -3.26522 +342 1 0.908217 4.16423 5.06292 -2.0575 1.13184 -0.501506 +343 1 0.771491 3.42595 5.87741 5.33449 1.31478 -10.6197 +344 1 0.14652 4.33584 6.04676 1.00462 -8.1578 -20.2597 +345 1 1.77294 3.51463 4.93957 -1.27898 -7.63546 3.32247 +346 1 2.71396 3.96357 4.97834 15.9141 3.79204 10.1307 +347 1 2.46159 3.38803 6.16546 -1.0491 -20.8555 -15.9327 +348 1 1.72608 4.39112 6.04032 -15.046 -11.018 -10.0045 +349 1 3.71274 3.40467 4.85974 -22.3519 13.9348 10.8973 +350 1 4.57553 4.21697 4.87404 -3.96399 7.00234 -1.98713 +351 1 4.366 3.53193 5.70269 7.89254 -3.17347 6.37497 +352 1 3.55123 4.20329 5.82208 -22.8323 -11.992 0.86056 +353 1 5.31479 3.43328 4.96004 -12.842 -18.3451 -4.95866 +354 1 5.96487 4.21664 4.98586 3.26728 12.2832 1.14917 +355 1 5.67633 3.58987 5.96581 6.91479 -13.8012 -0.0730494 +356 1 5.15168 4.48521 5.88819 -0.135174 -6.62981 7.61527 +357 1 6.76571 3.37692 5.24691 -14.8051 -2.47074 -4.50431 +358 1 7.42413 4.19524 5.01259 2.27671 4.46784 -0.576517 +359 1 7.6092 3.42318 5.84837 11.8264 -15.8262 -18.7291 +360 1 6.54398 4.29611 5.89957 10.509 -8.9195 -1.16059 +361 1 0.0247094 4.83566 4.99938 1.36656 0.603431 -2.15766 +362 1 0.966205 6.14847 4.9405 -1.84638 -2.56131 10.6129 +363 1 1.10739 5.11215 5.5368 -2.77114 7.32267 -6.17701 +364 1 0.221311 5.77966 5.62316 -16.3542 -5.99991 -34.5248 +365 1 2.09075 4.80339 4.88071 -15.5377 1.88455 -3.51044 +366 1 2.76626 5.59872 5.00497 -13.1053 -0.333159 -40.3797 +367 1 2.60002 4.95633 5.81939 -13.3057 -3.60712 -16.1699 +368 1 1.73302 6.11974 5.67311 7.80367 -13.5214 9.39307 +369 1 3.69174 5.11983 4.8182 4.27828 -13.6521 -3.16237 +370 1 4.24517 5.95869 5.19837 -53.2876 -10.1225 40.5156 +371 1 4.22774 4.94663 5.7496 8.19104 22.5118 -1.663 +372 1 3.1136 6.02947 5.80151 37.6339 -12.4217 36.265 +373 1 5.23537 5.12533 5.07481 2.14794 5.35663 -5.58383 +374 1 5.80775 6.19434 5.36474 -12.1517 -18.4331 -19.8184 +375 1 5.9697 5.18437 6.0003 -7.47906 6.99384 0.912527 +376 1 4.94854 5.8692 5.99559 17.5377 -1.26338 -12.9619 +377 1 6.59757 5.09144 5.08104 3.06742 4.08464 -2.92894 +378 1 7.54367 5.98613 4.88573 -14.2361 -23.7654 7.79426 +379 1 7.60847 5.23322 5.63185 -1.35187 -6.94343 4.2911 +380 1 6.70769 5.94816 5.81677 14.1283 2.13907 3.81564 +381 1 8.22278 6.71702 5.01662 22.4316 17.1972 -3.51396 +382 1 0.869349 7.28869 4.96667 -10.0366 3.62496 3.89926 +383 1 0.896793 6.73687 5.91431 -6.40765 3.74255 3.0528 +384 1 0.0890555 7.7054 5.6706 -5.18167 -47.9244 34.8448 +385 1 1.8751 6.88564 4.94229 0.477268 -2.00274 -5.71819 +386 1 2.7587 7.55291 4.99872 -36.0591 6.05211 43.0833 +387 1 2.53846 6.82983 5.7787 -13.9577 26.1772 12.6196 +388 1 1.63934 7.57104 5.79621 -1.51722 -4.07644 10.4552 +389 1 3.46612 6.83867 5.20388 -3.25728 -8.15264 -25.1259 +390 1 4.01792 7.77747 5.13143 8.22604 -9.98488 -11.0207 +391 1 4.0616 6.71165 5.99374 37.4635 -34.7522 2.57336 +392 1 3.49035 7.48383 6.06615 -52.3442 43.3465 -6.60384 +393 1 4.82693 6.8523 5.20763 2.69445 10.0085 20.3981 +394 1 5.83663 7.67662 4.94011 2.65651 0.782445 -0.458959 +395 1 5.60118 6.903 6.05259 0.51238 5.45548 -5.22943 +396 1 4.49984 7.67391 6.05154 31.0401 -0.647522 -9.371 +397 1 6.56806 6.92617 5.22736 4.49918 -20.7724 -24.6194 +398 1 7.45007 7.68748 5.02454 6.13987 -21.0163 7.77973 +399 1 7.49751 6.80367 5.78308 -9.98894 13.1501 -5.7166 +400 1 6.63057 7.61754 5.92417 0.0687578 21.3795 23.8905 +401 1 8.32557 8.34894 6.68981 0.104638 -13.8897 -9.6087 +402 1 0.744366 0.980723 6.48852 -5.23114 -31.7269 30.0044 +403 1 1.21108 0.262565 7.55604 -5.48851 -4.18087 -6.76609 +404 1 8.40118 0.701811 7.40569 17.4537 3.62996 11.6339 +405 1 1.79336 8.32699 6.64062 -5.93242 0.737609 -0.84307 +406 1 2.60519 1.4776 6.42908 -42.7477 -20.3947 10.8513 +407 1 2.68468 8.32969 7.50367 2.82039 -8.74718 0.911275 +408 1 2.14004 0.776947 7.26895 -3.65906 16.1309 -1.11008 +409 1 3.6569 0.0715803 6.70451 13.9675 -20.3473 29.1568 +410 1 3.94985 1.1248 6.78323 8.0083 0.919865 -1.94163 +411 1 4.44955 0.15543 7.5921 -15.5929 3.09145 7.2634 +412 1 3.18676 1.19789 7.55079 30.4701 -36.3009 -8.08868 +413 1 5.10396 0.131358 6.81912 -7.97923 37.9971 -21.1894 +414 1 5.81993 0.996314 6.79068 7.76858 -21.7284 -2.73997 +415 1 5.80025 8.18188 7.49322 12.3507 -13.1302 8.70784 +416 1 4.85408 1.28227 7.42764 -12.4579 -6.47968 -9.5274 +417 1 6.58875 0.130914 6.74241 2.12753 -2.2097 0.634037 +418 1 7.59964 0.676617 6.71682 -68.3673 2.07925 42.2066 +419 1 7.52212 0.0593286 7.5834 32.5631 3.04014 -28.8024 +420 1 6.85279 0.923554 7.57208 -4.28539 1.49265 -2.17621 +421 1 8.34941 1.72633 6.6429 -6.24486 10.7883 12.2426 +422 1 0.752277 2.47155 6.72526 -3.9412 -10.7788 3.00465 +423 1 0.813192 1.63555 7.42993 -7.74314 -11.2011 -0.638694 +424 1 8.22443 2.54813 7.66732 2.56273 -1.56785 0.82339 +425 1 1.49636 1.56107 6.38447 44.5625 33.4582 -3.13704 +426 1 2.30525 2.475 6.76961 -5.35408 6.54562 -0.949005 +427 1 2.49056 1.84724 7.59513 -61.407 9.30511 10.8314 +428 1 1.49273 2.39823 7.65033 13.5773 11.0727 -11.0854 +429 1 3.37689 2.03992 6.64219 17.5424 18.1797 1.52712 +430 1 4.36556 2.35363 6.72974 2.65202 20.8248 17.9478 +431 1 3.99822 2.02063 7.6547 18.3091 -10.0739 6.1027 +432 1 3.17328 2.55424 7.53823 -10.8617 31.8229 -4.73645 +433 1 5.21112 1.76508 6.50479 -18.4173 6.52495 3.64931 +434 1 5.87572 2.50861 6.47972 17.6588 16.4017 11.3405 +435 1 6.13161 1.75643 7.42519 -6.35346 6.11936 8.80778 +436 1 5.08243 2.27965 7.49559 3.10695 14.763 0.591819 +437 1 6.90515 1.73737 6.69685 6.36969 -4.89015 -2.67266 +438 1 7.59965 2.63279 6.71489 9.55617 -0.301288 -8.47778 +439 1 7.76189 1.52013 7.52701 3.93719 -1.66085 -6.19761 +440 1 6.70724 2.6779 7.2598 -8.99322 4.2321 11.9078 +441 1 0.125444 3.31521 6.66881 -20.5423 -11.9528 1.08126 +442 1 0.364694 4.22273 7.06 15.4688 8.78987 -5.27721 +443 1 0.60791 3.34758 7.65433 9.81501 -30.9601 -14.2913 +444 1 8.0984 3.85412 7.73406 0.295867 21.4592 0.238003 +445 1 1.38869 3.28611 6.86269 8.50148 8.2104 -0.813622 +446 1 2.52476 4.25334 6.66316 13.9982 13.4488 20.9739 +447 1 2.34408 3.26799 7.64808 -1.14502 9.26403 -10.1755 +448 1 1.45935 4.43411 7.31503 0.0272838 -0.538431 -2.52173 +449 1 3.66593 3.34626 6.65797 -1.50742 -4.19973 -15.7128 +450 1 4.32339 4.28741 6.63848 -1.71153 0.00989822 -0.270268 +451 1 4.03917 3.1404 7.61252 24.7136 -10.2891 3.12208 +452 1 3.36907 3.93473 7.50701 -10.481 -0.383957 -6.9951 +453 1 4.88527 3.3354 6.73465 -0.250758 1.18323 3.20962 +454 1 5.86197 4.30684 6.74144 -6.02175 10.4775 -12.9313 +455 1 5.83143 3.4729 7.33725 -5.24712 -23.3614 7.27214 +456 1 5.04517 4.19893 7.47372 14.0277 -13.7659 1.86079 +457 1 6.67093 3.19494 6.32389 -1.08882 16.2366 5.3564 +458 1 7.58567 3.93824 6.68879 13.8607 17.9546 17.9945 +459 1 7.41034 3.22296 8.01852 -22.7502 -28.7124 0.282368 +460 1 6.74041 3.98357 7.25541 -1.38378 3.03134 11.4432 +461 1 8.11164 5.05821 6.64701 -10.3621 4.23498 3.48281 +462 1 0.434229 5.95598 6.55583 13.6324 -1.56553 39.6492 +463 1 0.429061 5.17903 7.41995 -0.29478 -7.71855 -15.5486 +464 1 8.09598 5.94892 7.38464 -0.670206 -2.17368 6.38869 +465 1 1.41611 5.29567 6.55129 0.191903 6.07763 6.12613 +466 1 2.44376 5.87825 6.63669 -4.18767 0.226771 1.1996 +467 1 2.57445 4.71437 7.62895 -9.06207 26.6712 -23.195 +468 1 1.76163 5.67875 7.56712 4.16416 -0.382203 -1.94173 +469 1 3.23562 5.1121 6.55719 20.8924 -0.347412 22.4145 +470 1 4.05367 5.80831 6.49809 -13.6658 -13.8236 9.34588 +471 1 4.3499 4.91428 7.57309 -17.8958 19.2373 1.53594 +472 1 3.33848 5.81136 8.0112 0.629066 -2.48199 -2.55986 +473 1 5.22933 5.24678 6.83002 -9.21161 -10.3226 -4.65561 +474 1 5.87231 6.12998 6.73434 -14.492 -21.708 -7.10976 +475 1 6.102 5.06631 7.42095 8.16162 7.57706 8.09799 +476 1 5.11386 5.85851 7.69037 1.37823 -1.01778 -7.91082 +477 1 6.94866 5.10876 6.52261 -0.00645701 0.734687 4.76591 +478 1 7.67078 6.01392 6.41167 -4.02477 -14.728 2.57416 +479 1 7.35061 4.96205 7.5433 24.0095 -18.1944 -20.4412 +480 1 6.9284 5.83495 7.63045 -18.4707 37.5628 2.3937 +481 1 8.28984 6.85999 6.50497 12.0319 11.2505 5.01489 +482 1 0.775248 7.71516 6.80461 7.24585 -11.6558 8.08417 +483 1 0.533688 6.7762 7.54365 3.89137 -4.31915 -15.8578 +484 1 8.2465 7.61079 7.46416 25.9419 0.696332 -26.8887 +485 1 1.73177 6.71435 6.78434 -8.61422 -0.737705 -7.23833 +486 1 2.48272 7.50206 6.80041 12.0152 -3.31551 -7.82219 +487 1 2.37093 6.72113 7.64339 9.62293 -9.48685 2.94166 +488 1 1.77272 7.59226 7.58949 -2.97267 7.70343 0.621675 +489 1 3.29197 6.66554 6.74519 -6.55378 -4.76021 6.1499 +490 1 4.04728 7.44441 6.9325 9.38301 -4.09453 15.5296 +491 1 4.12674 6.55075 7.78018 3.09461 4.03017 -1.80654 +492 1 3.3807 7.43243 7.7243 -9.78058 -0.600287 9.7772 +493 1 4.74428 6.55735 6.78071 12.1641 10.0813 15.0085 +494 1 5.30209 7.56833 6.75011 8.90694 -20.2013 0.20059 +495 1 5.88783 6.83008 7.50111 -3.28565 3.55282 5.18781 +496 1 4.85536 7.429 7.66393 -0.8844 -0.824359 14.1315 +497 1 6.78323 6.58213 6.75112 16.4005 10.5566 0.00129152 +498 1 7.49771 7.53891 6.69245 -0.0692693 6.11315 -11.5276 +499 1 7.61589 6.80831 7.76686 -5.70997 -4.77696 -9.529 +500 1 6.80731 7.4637 7.45575 -10.489 5.43873 12.05 +ITEM: TIMESTEP +200 +ITEM: NUMBER OF ATOMS +500 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 8.41242 8.26599 8.38785 -10.0358 6.58437 5.2801 +2 1 0.814162 0.710931 0.0523899 -37.3452 31.5986 3.80166 +3 1 0.707188 8.3394 0.783901 7.22527 -6.84977 10.4166 +4 1 0.078844 0.75192 1.11978 38.2878 -8.01586 -1.83777 +5 1 1.52052 0.0613493 8.33894 50.642 -18.5757 54.2409 +6 1 2.63022 0.777198 -0.0136511 -14.6872 26.2087 -8.24369 +7 1 2.86573 8.3667 0.519039 4.98442 -20.5506 12.9041 +8 1 1.4757 0.711348 0.992341 22.4024 -8.05229 -33.8354 +9 1 3.79318 8.20698 8.14977 -12.6173 11.8638 7.05406 +10 1 4.0381 1.06879 8.36154 -11.3644 -3.77089 -31.1235 +11 1 3.94622 0.00241404 0.83531 3.0713 5.57971 3.39388 +12 1 3.2904 1.19609 0.697286 11.5663 -9.90219 11.4209 +13 1 4.80931 8.28217 0.152557 1.5084 -10.3853 -19.3359 +14 1 5.59181 0.724855 8.1093 -26.5323 12.4899 -7.60558 +15 1 5.68752 0.120676 0.713607 11.3113 1.42738 1.49966 +16 1 4.78554 0.81043 0.585131 26.0655 -22.1296 9.76004 +17 1 6.43613 0.237453 8.26775 30.1844 -14.2258 6.08634 +18 1 7.5043 0.643436 0.0691857 2.69659 0.617275 -0.831401 +19 1 7.7682 0.0476766 1.0238 2.88283 -8.74262 5.4154 +20 1 6.83111 0.459822 0.931748 -10.2254 10.6222 -23.4955 +21 1 0.00401405 1.51379 8.26626 1.73444 -9.97848 2.73777 +22 1 0.631563 2.29056 0.214422 2.30445 -4.73927 -16.4851 +23 1 0.869727 1.5347 0.919411 -20.3113 -10.6479 -1.82401 +24 1 -0.0840974 2.27001 1.15035 26.4165 13.702 -18.8298 +25 1 1.67911 1.38813 0.0883733 4.29152 4.16945 3.72554 +26 1 2.34463 2.397 8.3967 -0.661743 10.3894 16.138 +27 1 2.41792 1.69378 0.837891 -11.9994 8.17272 5.13712 +28 1 1.50784 2.3296 0.8821 15.8347 5.46342 -6.24169 +29 1 3.19181 1.77289 8.14083 -8.92279 -4.86777 22.8625 +30 1 4.12817 2.46218 8.33741 8.13153 -11.9637 0.536015 +31 1 4.26337 1.62555 0.809789 -13.061 44.2943 -8.13534 +32 1 3.42316 2.33556 0.802814 -4.29938 0.254861 -1.13643 +33 1 5.0669 1.62594 8.33933 -4.47953 5.08137 -8.2197 +34 1 5.91213 2.40952 0.124369 -13.9 -26.0969 3.99436 +35 1 6.23275 1.281 0.442008 -1.76602 1.09435 0.219677 +36 1 5.05785 2.29128 0.753897 1.63462 9.40663 2.64296 +37 1 6.76196 1.99075 8.08873 7.25593 -6.72787 12.2575 +38 1 7.89568 2.35083 0.217856 -14.3986 10.074 -11.1844 +39 1 7.7557 1.40697 0.992421 -28.0785 15.2332 -13.5573 +40 1 6.69672 2.20109 0.984157 0.465363 17.7913 -13.2761 +41 1 8.2159 3.42858 0.185567 12.3977 0.764361 -3.90376 +42 1 0.927092 4.2442 8.41258 -26.45 -26.3493 -4.33489 +43 1 0.729094 3.09987 0.813639 -4.58702 16.175 15.6607 +44 1 0.0788068 4.49033 1.02182 1.48174 1.40892 2.78463 +45 1 1.55842 3.1508 0.126599 -1.73889 6.5262 3.04002 +46 1 2.29185 4.09245 0.0493365 -0.242842 -5.39025 -0.756334 +47 1 2.41785 3.22623 0.89121 8.0106 -0.183268 -6.38994 +48 1 1.56843 4.03679 0.931375 1.76309 0.26565 -2.14494 +49 1 3.4359 3.23233 0.0225532 -4.36687 10.8322 6.25926 +50 1 4.25669 4.07361 0.0880133 2.8279 3.66932 -9.72921 +51 1 4.34048 3.08558 0.785495 -4.69141 6.70607 0.15029 +52 1 3.59299 3.90329 0.886528 -10.5717 12.5753 -2.99495 +53 1 5.13064 3.04982 8.22833 -0.225212 8.61676 17.0697 +54 1 5.81502 4.09178 8.38841 -21.2737 -2.05468 -24.8502 +55 1 5.97613 3.1773 0.894798 -5.61602 -19.9636 -19.3342 +56 1 5.09497 3.91821 0.747666 0.511602 -0.648627 8.1507 +57 1 6.51767 3.18724 8.3864 17.647 23.2966 -13.5196 +58 1 7.37164 4.03522 8.29689 -11.4262 -6.53116 -1.21962 +59 1 7.31211 3.24078 0.704535 -4.3132 -0.596821 4.84194 +60 1 6.56447 4.1734 0.602333 27.4745 -11.0091 36.7473 +61 1 8.15631 4.68203 0.075112 10.7012 -10.9934 -7.99724 +62 1 1.11663 5.88929 8.3609 -7.93077 -20.1145 9.26986 +63 1 0.996074 4.97243 1.21409 -6.72433 0.768332 -3.74364 +64 1 0.189403 5.66667 0.913187 -7.3538 -1.57168 -7.21317 +65 1 1.58163 4.94764 0.201022 19.1991 11.3216 -0.454803 +66 1 2.29237 5.73911 0.0748948 8.80602 19.0835 -4.47029 +67 1 2.49097 4.65203 0.981363 3.25616 8.72811 -9.97843 +68 1 1.87095 5.55306 0.995907 1.03553 19.7133 11.0025 +69 1 3.18407 5.012 0.131558 5.578 6.2636 9.58863 +70 1 4.09719 5.68255 0.132658 4.03261 5.63654 -2.85988 +71 1 4.12395 4.88832 0.852082 2.34539 -1.75572 -18.9743 +72 1 3.07234 5.70133 0.969327 -0.346407 5.49919 1.56796 +73 1 5.11274 5.00399 0.171908 -9.99815 3.39538 19.3609 +74 1 5.76656 5.80521 0.11529 9.4035 3.26414 21.2303 +75 1 6.01079 5.05469 0.873922 -27.3446 -31.3954 -10.6646 +76 1 4.89913 5.95208 0.960158 8.00863 4.38535 -8.86024 +77 1 6.75863 4.93475 8.31779 -18.6284 14.8779 13.2188 +78 1 7.8245 5.62001 8.34465 11.2383 14.3374 0.909184 +79 1 7.51856 5.31135 0.853265 4.91639 -9.6583 11.5193 +80 1 6.62461 5.81662 0.841147 8.94471 25.6435 -17.3923 +81 1 0.202013 6.46046 8.33455 0.0609498 5.25542 6.45446 +82 1 0.889578 7.53674 8.33221 1.62686 -1.40391 0.0530776 +83 1 0.953366 6.38848 0.908196 -1.46223 4.85455 -5.86941 +84 1 0.145952 7.39993 0.791819 5.48829 -5.75958 -9.51465 +85 1 1.67676 6.71324 8.36121 2.78795 2.25277 6.97945 +86 1 2.21164 7.54618 8.16806 16.5579 9.64776 9.50482 +87 1 2.40278 6.62803 0.856512 -0.674903 -8.3487 -4.56859 +88 1 1.53782 7.38975 0.90846 -3.10291 8.8481 -14.5459 +89 1 3.27325 6.398 0.0420856 1.14847 -3.14438 14.8868 +90 1 4.24204 7.28724 8.33928 2.62398 3.89094 44.6004 +91 1 4.04999 6.6211 0.862788 13.5756 -10.8829 -5.05866 +92 1 3.45704 7.41684 0.605416 -19.3758 10.5723 4.19592 +93 1 5.13383 6.59732 8.2884 -30.4967 14.0841 16.2852 +94 1 5.83566 7.60311 0.0824633 -14.5596 3.16754 7.91958 +95 1 5.71227 6.86684 0.81732 11.5827 -10.7391 -7.91805 +96 1 4.90381 7.61313 0.94797 9.27737 -4.87268 -6.49352 +97 1 6.72722 6.86314 0.253587 -5.2734 -0.113759 -0.620065 +98 1 7.41232 7.77996 0.331703 18.857 -4.07135 -25.363 +99 1 7.56998 6.39348 0.735875 7.28329 1.56003 -0.789213 +100 1 6.66601 7.84216 0.965777 -32.1881 -17.8038 12.8266 +101 1 0.166766 -0.00131261 1.94063 8.32296 1.94608 -3.28266 +102 1 0.934833 0.817938 1.81275 -21.8629 -14.287 17.2076 +103 1 1.00207 0.316008 2.82556 -21.807 -5.91521 -4.01431 +104 1 8.35945 0.74 2.72116 2.32177 4.37751 -0.902675 +105 1 1.48465 8.25372 1.60749 -1.18562 -7.12983 8.20441 +106 1 2.44318 0.774258 1.4766 5.48942 -2.99924 2.57908 +107 1 2.3069 8.18025 2.36522 1.41087 2.4731 2.95424 +108 1 1.85775 0.858752 2.6061 9.12182 6.5265 -4.79678 +109 1 3.23269 0.0488049 1.82801 0.784922 27.4455 -30.2613 +110 1 4.21175 0.99942 1.57195 -9.49462 -27.3711 22.4225 +111 1 4.21293 0.25409 2.38861 -7.75181 -9.25535 -4.23311 +112 1 3.32934 0.964581 2.65137 -6.01516 -9.0041 -1.19732 +113 1 4.9787 0.193499 1.50831 -4.98755 -8.3429 -3.28083 +114 1 6.09517 0.531101 1.76326 -28.5995 19.6806 -10.71 +115 1 5.85753 8.23852 2.51303 -1.20503 -8.99564 8.87124 +116 1 5.17785 0.685106 2.40543 -1.30449 11.3507 4.36005 +117 1 6.91213 8.37413 1.83271 8.62238 -24.2277 10.2354 +118 1 7.62368 0.758482 1.85178 16.0234 8.8439 -5.1341 +119 1 7.66132 8.34118 2.51601 5.03438 -8.87196 18.1761 +120 1 6.82917 0.875718 2.51872 -7.12717 1.70889 8.15245 +121 1 0.0949053 1.53257 1.83348 -15.8355 -28.5862 13.9628 +122 1 0.822415 2.21502 1.73119 16.0449 19.2167 -17.682 +123 1 0.864878 1.50475 2.57372 12.4143 -0.0682656 8.67505 +124 1 0.199844 2.34986 2.54349 -13.4424 7.82132 10.7389 +125 1 1.68463 1.52556 1.71378 7.71699 13.5023 1.83995 +126 1 2.69369 2.59616 1.91546 -20.6965 -6.26723 -3.29779 +127 1 2.60471 1.76603 2.62425 -5.19989 2.78858 2.334 +128 1 1.44056 2.43723 2.51936 11.6798 4.82752 9.65183 +129 1 3.43446 1.65477 1.84942 -9.01773 7.52097 -5.37653 +130 1 4.19061 2.39179 1.65045 11.7616 -7.21515 -2.54075 +131 1 4.26672 1.39737 2.67586 10.1937 6.39563 -7.12371 +132 1 3.53921 2.577 2.549 6.10272 -3.10086 8.1996 +133 1 5.17395 1.33784 1.40963 0.810412 -15.8822 3.29742 +134 1 5.74074 2.13809 1.54869 21.9361 25.9957 -3.59082 +135 1 5.9363 1.515 2.34901 -9.46258 -12.7333 10.9894 +136 1 4.95982 2.19781 2.39856 0.709797 0.431383 -4.3853 +137 1 6.78917 1.32128 1.47071 -5.63197 2.68115 20.8841 +138 1 7.62581 2.16504 1.87345 17.6788 -6.34038 -2.38007 +139 1 7.68847 1.62015 2.88771 -1.999 -29.1097 -18.0204 +140 1 6.72066 2.18015 2.22288 -25.5596 -3.13399 14.9826 +141 1 8.10556 3.24278 1.47587 8.10057 -1.81275 -31.7951 +142 1 0.698788 3.89936 1.58833 21.0059 -8.7854 2.84332 +143 1 0.726156 3.39424 2.59236 2.18368 -0.846434 0.375997 +144 1 8.21488 4.03893 2.09204 -9.31366 21.6556 21.1016 +145 1 1.61294 3.13444 1.56982 -6.75222 2.4564 11.7453 +146 1 2.47309 3.97186 1.76449 2.21347 -7.98753 7.5428 +147 1 2.67292 3.22702 2.95068 5.54423 5.59107 -13.8219 +148 1 1.72826 4.2557 2.53344 -3.42962 -20.862 21.8798 +149 1 3.48214 3.13902 1.56572 3.70104 11.9942 4.11222 +150 1 4.3885 3.8788 1.62665 2.95307 16.2819 -22.5535 +151 1 4.3065 3.38859 2.48531 -9.81397 -19.0665 24.4754 +152 1 3.47101 4.13314 2.35987 0.052847 -5.96917 4.43729 +153 1 5.11162 3.02695 1.57487 -2.09605 4.71156 2.60925 +154 1 6.05823 3.77666 1.6683 -0.0795953 27.02 22.5131 +155 1 5.89604 2.8633 2.33341 1.61726 0.0933652 1.12851 +156 1 5.29152 3.73349 2.43504 2.35223 15.5067 -10.4051 +157 1 6.82698 3.04592 1.66447 4.37333 2.796 -3.08497 +158 1 7.47158 4.33914 1.21316 -2.11938 -7.51647 -10.9268 +159 1 7.68828 3.1018 2.37066 -8.14673 6.79824 16.7729 +160 1 7.09384 4.0081 2.08909 -5.93874 -19.0069 4.73504 +161 1 8.1255 5.22391 1.77055 19.2122 -25.3413 6.96334 +162 1 0.62612 5.90176 1.99772 9.96713 -14.5554 -17.3464 +163 1 0.76801 4.79289 2.36504 -2.78355 1.48316 -1.85895 +164 1 8.18318 5.95034 2.62286 5.26633 -16.349 1.23379 +165 1 1.81648 4.94963 1.84319 1.29255 4.07737 -28.8924 +166 1 2.40619 6.07189 1.89723 9.11627 0.0929027 -31.5253 +167 1 2.58707 5.01704 2.50938 -14.4694 3.44726 -14.5204 +168 1 1.72272 5.71364 2.51972 -25.0056 3.38939 29.4203 +169 1 3.42498 4.85355 1.57173 -14.1697 1.2804 16.3608 +170 1 4.15303 5.79502 1.71807 -6.58651 -0.238746 -3.12281 +171 1 4.46167 4.86212 2.18786 -1.52672 -11.6836 -0.120829 +172 1 3.29589 5.94757 2.4039 5.86702 -13.0661 19.8541 +173 1 5.03295 4.96131 1.30642 14.6935 -5.33684 5.62219 +174 1 5.82775 5.80433 1.62537 -3.48018 5.04048 -3.36734 +175 1 5.79583 4.80394 2.11298 -5.34853 -5.63002 0.159279 +176 1 5.01708 6.04912 2.32216 17.4276 -29.4439 17.4564 +177 1 6.71539 5.10912 1.63093 10.3915 -7.52696 11.1074 +178 1 7.41693 5.91425 1.78268 -24.8131 17.7871 4.30264 +179 1 7.12646 4.86445 2.63426 13.6393 21.9613 3.08537 +180 1 6.42336 6.18201 2.43584 15.1603 10.9548 -7.96948 +181 1 8.23881 6.55347 1.60468 9.12903 0.565206 1.23333 +182 1 0.678624 7.37322 1.88745 -5.46988 3.49615 -25.4292 +183 1 0.794621 6.6529 2.67297 0.0873755 -1.33888 6.26964 +184 1 8.30959 7.39568 2.5723 10.9372 15.1486 20.2523 +185 1 1.53592 6.72715 1.69313 10.3025 -8.32698 21.6565 +186 1 2.52873 7.48993 1.45805 2.51224 9.72508 0.958573 +187 1 2.57516 6.97533 2.39376 0.331622 5.62636 7.11361 +188 1 1.48127 7.49186 2.513 25.359 1.87736 0.862705 +189 1 3.42472 6.67917 1.69715 -9.14691 10.5288 -4.39359 +190 1 4.07864 7.56162 1.54537 -20.7523 -1.21573 5.0956 +191 1 4.22077 6.65705 2.50099 -12.9989 13.269 2.80638 +192 1 3.32476 7.76609 2.51834 12.0821 -31.6775 22.1813 +193 1 5.18316 6.78911 1.6853 -16.2098 8.5059 -12.8052 +194 1 5.76367 7.66024 1.61411 8.21393 8.40414 -2.16429 +195 1 5.72928 6.97443 2.55641 -4.2085 8.68736 -3.41382 +196 1 4.81509 7.65411 2.27112 9.64741 4.31731 11.3389 +197 1 6.71673 6.6577 1.40921 -4.23135 13.1654 3.72162 +198 1 7.9523 7.57862 1.62003 -19.0505 2.7611 2.11499 +199 1 7.55182 6.74669 2.5625 -26.4699 -4.16644 -1.81267 +200 1 6.71006 7.32273 2.23599 -2.19037 10.3011 3.68982 +201 1 8.3209 8.25724 3.44082 -11.2006 13.9316 -31.0885 +202 1 1.1383 0.707726 3.88488 2.87074 16.2111 -29.5751 +203 1 0.710637 8.17953 4.00977 26.7141 2.01724 45.2521 +204 1 0.017483 0.84611 4.17688 -4.01486 -16.4278 3.15279 +205 1 1.83485 0.022043 3.36625 6.99225 9.16158 -10.2142 +206 1 2.5734 1.02544 3.4638 -2.67645 -0.861554 5.53773 +207 1 2.46831 8.35234 4.18841 -8.88118 2.57467 1.82808 +208 1 1.9704 0.882634 4.50547 -3.01692 -0.258051 -7.68015 +209 1 3.15194 0.11929 3.26603 1.99843 -0.203753 6.521 +210 1 4.16362 0.594977 3.39201 1.91533 3.30238 12.0146 +211 1 4.48096 8.3197 4.27248 -34.7907 27.9025 -6.28307 +212 1 3.49096 0.991035 4.39487 -18.0924 -11.2469 -3.89782 +213 1 5.15221 8.33246 3.40287 -4.49662 4.44033 -5.3065 +214 1 5.83668 0.780008 3.22544 8.18869 5.41063 4.37051 +215 1 5.71056 8.31473 4.3397 -0.683085 13.1798 -1.88784 +216 1 5.01734 0.796017 4.33297 -1.83196 10.7479 -11.7081 +217 1 6.55531 0.0226915 3.33292 8.64001 -7.40459 4.85944 +218 1 7.40254 0.734891 3.44283 9.92215 2.2266 -9.49047 +219 1 7.60175 8.41313 4.17692 -11.7492 9.12522 14.6015 +220 1 6.69717 0.884026 4.20434 -2.52907 -5.48675 3.38708 +221 1 0.266587 1.50956 3.42506 -7.49445 4.66836 1.70669 +222 1 0.834612 2.3929 3.4535 3.19311 14.9998 -2.79098 +223 1 0.966342 1.70753 4.27772 -2.38166 -3.63555 7.29451 +224 1 8.31528 2.54359 4.03878 16.7451 -1.36482 20.306 +225 1 1.65675 1.69619 3.39484 3.12529 -6.34044 -1.62009 +226 1 2.21998 2.62053 3.66497 -8.94713 -4.89956 5.05059 +227 1 2.70158 1.84855 4.22365 -4.21065 -7.00328 -1.279 +228 1 1.73069 2.39291 4.69998 -11.0397 -15.2385 -11.7518 +229 1 3.63597 1.81901 3.49635 -5.37102 -6.0004 0.428615 +230 1 4.5181 2.45307 3.50704 1.92291 5.38714 1.37796 +231 1 4.28022 1.61295 4.532 11.684 13.523 -0.759472 +232 1 3.49161 2.67545 4.21356 3.70186 4.50981 -2.53687 +233 1 5.05676 1.45985 3.45113 -18.7528 -7.6908 -2.02124 +234 1 5.59639 2.31007 3.23954 13.071 6.11501 -14.1907 +235 1 5.90515 1.58558 4.07201 2.34854 -1.44676 5.83562 +236 1 5.6448 2.61062 4.20904 5.92031 11.7583 11.4648 +237 1 6.60245 1.81532 3.22394 -0.344578 -17.0844 -10.2298 +238 1 7.7209 2.5366 3.23021 -13.9757 26.3091 7.5372 +239 1 7.59991 1.69339 4.17685 -3.31209 -2.6982 -2.62135 +240 1 6.7571 2.48096 3.97019 3.90879 12.298 15.8753 +241 1 8.32132 3.59836 3.32434 15.1974 -18.6025 -8.65377 +242 1 0.758776 4.28533 3.41911 8.12571 10.2206 -6.43372 +243 1 0.714283 3.43939 4.05789 10.8012 -17.4951 -4.32355 +244 1 8.37038 4.20103 4.16336 -19.0683 10.428 -9.16118 +245 1 1.7111 3.58985 3.37102 -4.50013 -9.39619 -9.22108 +246 1 2.7295 4.29586 3.34058 -27.7709 -28.5377 3.76594 +247 1 2.75779 3.49033 4.0215 3.07014 12.8072 -10.7423 +248 1 1.81597 4.04867 4.27403 8.34757 5.06165 3.43123 +249 1 3.63217 3.50284 3.43026 7.64322 -9.23013 -17.5251 +250 1 4.42979 4.3957 3.21235 -5.21891 -3.02116 0.669719 +251 1 4.46277 3.52681 4.13413 -5.3566 -4.51807 -16.5208 +252 1 3.52987 4.30614 4.06609 5.60483 14.7001 10.5939 +253 1 5.31574 3.44078 3.42467 1.48508 -5.70873 13.1076 +254 1 6.44336 4.14284 2.93215 -36.0911 1.99853 0.657603 +255 1 6.52296 3.60341 4.02819 -0.573509 -3.99567 -1.18998 +256 1 5.23388 4.48156 3.97453 6.55779 -4.33302 -0.590571 +257 1 6.75544 3.08581 2.98548 -20.753 -29.7898 -6.93237 +258 1 7.36113 3.83069 3.18965 17.3707 23.8596 11.1094 +259 1 7.68707 3.36428 4.36221 -8.90323 13.3285 -23.8114 +260 1 6.58157 4.70256 3.96292 -12.6487 -1.89838 -2.64764 +261 1 8.03895 4.72186 3.2072 7.03567 0.390199 -0.150374 +262 1 0.641986 5.57832 3.32415 -3.93783 9.97933 -29.9316 +263 1 0.748525 5.2954 4.26917 10.3198 11.1143 16.7142 +264 1 8.33552 6.07931 4.24855 1.05812 -13.5964 19.1647 +265 1 1.90145 4.96491 3.42288 -7.34814 1.12325 1.52157 +266 1 2.61408 5.80343 3.49254 4.58835 0.11833 -14.0758 +267 1 2.80014 5.15473 4.32615 -31.6367 11.9713 -55.3412 +268 1 1.9564 6.07585 4.27618 -9.91164 -20.8823 -47.0179 +269 1 3.37946 4.96765 3.07865 55.664 27.3093 14.9143 +270 1 4.23608 5.59453 2.88525 -18.9133 13.1689 8.33969 +271 1 4.44604 5.19737 4.14454 -7.57666 -13.265 -14.5347 +272 1 3.6416 5.84891 3.83409 2.65328 -4.22633 -4.19185 +273 1 5.15151 5.25659 3.1676 14.0924 -4.2121 3.02426 +274 1 5.82306 6.30397 3.36345 -4.54273 -6.47443 0.566248 +275 1 5.74908 5.5163 4.09569 25.3818 -3.33304 -26.8083 +276 1 4.83867 6.14359 3.79115 -4.65662 -0.583485 3.38738 +277 1 6.22614 5.32285 2.95137 -4.13422 -8.32687 15.6358 +278 1 7.32122 5.97196 3.33835 -0.00434101 -1.28454 -1.88403 +279 1 7.49659 5.17369 4.09183 8.55988 6.64783 3.63555 +280 1 6.75151 6.22479 4.25773 -16.211 -27.6787 -10.8075 +281 1 8.29215 6.64155 3.42114 5.59717 18.8581 -19.6047 +282 1 0.763473 7.56557 3.23404 -12.9198 -1.64007 -15.2341 +283 1 1.0031 6.68313 3.72439 -4.3972 -14.7662 15.3222 +284 1 8.23363 7.61771 4.35977 7.30279 -9.1197 2.90547 +285 1 1.95141 6.6466 3.21786 0.736159 0.439247 -2.07076 +286 1 2.6385 7.59536 3.37124 -4.27783 -4.21174 -0.733124 +287 1 3.13092 6.60025 4.41497 -19.4938 11.5887 -14.0245 +288 1 1.65818 7.53719 3.85187 -1.11019 -9.22082 13.1065 +289 1 3.27775 6.71474 3.27823 1.67015 1.07042 -3.65835 +290 1 4.1525 7.8844 3.3351 -7.70608 -2.7891 -4.06245 +291 1 3.98551 7.08252 4.24517 31.7093 2.51435 -5.83578 +292 1 3.40048 7.93533 4.31596 7.03572 3.0716 -3.37554 +293 1 4.94636 7.13355 3.35885 -28.0161 -11.5072 -5.66389 +294 1 5.84413 7.52046 3.45751 31.3517 19.8289 8.4284 +295 1 5.90459 6.85513 4.30093 -7.30307 7.57049 -1.80424 +296 1 5.01344 7.53745 4.4217 23.0153 -42.676 2.37557 +297 1 6.69892 6.88846 3.31402 6.29068 2.24472 -2.02408 +298 1 7.47533 7.68601 3.37673 -12.6934 -11.1052 -3.87233 +299 1 7.49921 6.86202 4.09322 12.1924 13.0141 4.3943 +300 1 6.67133 7.90635 4.38865 4.30856 -16.1011 -10.8357 +301 1 8.27296 0.0768914 5.12036 9.18301 -5.97843 0.553246 +302 1 0.892643 0.477473 4.83579 -15.0913 15.4009 20.7636 +303 1 0.772154 0.130661 5.99646 -1.43861 1.07866 -2.10387 +304 1 8.25515 0.935072 5.88754 -0.221723 -11.6722 -2.23691 +305 1 1.48963 8.06671 4.97048 16.9477 -1.8997 -3.71962 +306 1 2.57496 1.15847 5.28752 41.8653 -9.27812 4.61709 +307 1 2.98732 0.492219 6.35067 -4.54422 -4.60939 3.20868 +308 1 1.84275 0.524647 5.86961 -0.917224 0.841047 0.660751 +309 1 2.97903 0.200446 5.09803 7.97745 -0.922342 6.62523 +310 1 4.26317 0.578438 5.09777 -3.02519 11.3137 -4.68966 +311 1 4.18994 0.120263 6.02339 -4.93913 2.59189 23.6551 +312 1 3.50295 1.24619 5.79637 -4.00764 -7.55023 -4.67003 +313 1 5.12205 8.32679 5.40632 -5.25746 3.73248 -3.11501 +314 1 5.80677 0.859185 4.97868 15.281 -0.410171 8.11126 +315 1 6.05354 -0.0201647 5.97574 -7.51195 2.16668 5.49645 +316 1 5.29101 1.10125 5.89955 -0.302158 5.37706 -3.33259 +317 1 6.70998 0.244047 5.12411 -32.2188 -6.24411 4.81733 +318 1 7.52467 0.777062 4.96861 20.8677 24.3354 -3.82818 +319 1 7.29721 0.136872 5.99355 7.05953 -3.3845 7.97045 +320 1 6.54852 0.902142 6.09075 8.2259 10.3777 -12.9847 +321 1 8.3753 1.53724 4.98157 2.17311 8.15625 3.98817 +322 1 0.71432 2.51412 5.02068 -12.4966 -5.84806 3.10051 +323 1 0.855781 1.46858 5.93628 -12.4576 1.96544 0.341226 +324 1 8.11454 2.43493 5.75559 5.15623 -3.74122 1.07022 +325 1 1.70238 1.57115 5.35189 -38.5773 5.62525 -16.043 +326 1 2.46473 3.0428 4.8535 14.9609 2.21644 20.6584 +327 1 2.4829 2.11442 5.80082 20.2757 20.5564 -2.76238 +328 1 1.44662 2.4329 5.9576 0.543772 11.9562 -7.2005 +329 1 3.29597 2.05528 5.06702 2.85074 -1.27902 5.48838 +330 1 4.71392 2.67227 4.67311 -16.586 -2.70867 4.26173 +331 1 4.23981 1.93327 5.61065 17.5416 10.5589 -1.008 +332 1 3.69151 2.91031 5.72032 0.213325 2.13196 -1.69169 +333 1 5.26041 1.83667 5.02123 6.06702 -8.01086 0.159199 +334 1 6.29681 2.56022 5.09106 -5.44623 -0.683824 -15.8447 +335 1 5.97089 1.97948 5.90875 -1.39581 -8.65091 2.36208 +336 1 5.32016 2.78712 5.54952 10.0834 -7.57686 9.12967 +337 1 6.76335 1.53665 5.10381 -6.49311 3.28388 -1.62508 +338 1 7.39244 2.59867 4.94069 -6.65618 -18.4022 10.6664 +339 1 7.39034 1.59037 5.98163 7.99848 2.50507 -1.85372 +340 1 6.86792 2.60296 5.96513 8.836 -3.98323 2.68287 +341 1 0.137435 3.52069 4.93684 -4.66205 -5.7882 5.56144 +342 1 0.88525 4.34994 4.6075 2.988 -8.04302 19.8618 +343 1 0.671447 3.60221 5.79043 18.0943 -16.6493 20.2037 +344 1 8.34285 4.28087 5.95434 -19.6744 13.1619 0.969809 +345 1 1.33416 3.36295 4.99473 8.92189 5.92429 -2.5153 +346 1 2.50305 4.23267 5.05465 -27.5248 -20.908 0.492103 +347 1 2.36725 3.37012 5.84923 -17.1073 -9.96579 7.0021 +348 1 1.45211 4.29673 5.57493 7.54138 6.26423 2.50823 +349 1 3.47656 3.71778 4.99943 12.588 -10.9937 -32.8348 +350 1 4.53758 4.28685 4.7978 -5.49767 21.5926 5.59595 +351 1 4.66123 3.56451 5.54467 -12.8933 9.0868 3.25853 +352 1 3.16215 4.0016 5.8872 6.62501 12.8548 34.5501 +353 1 5.39268 3.59146 4.74919 -4.73905 -31.3011 -11.4087 +354 1 5.76113 4.47956 4.9574 18.7428 32.3973 -5.18443 +355 1 5.78815 3.80587 5.78982 -7.10304 0.117864 -2.90029 +356 1 5.02789 4.67913 5.68892 -14.5359 -3.59396 7.83253 +357 1 6.67716 3.56196 5.1655 1.61752 2.79183 -0.67852 +358 1 7.59448 4.24592 4.9803 -6.50366 -1.98045 6.72657 +359 1 7.59718 3.39514 5.76655 2.21878 7.1556 0.646608 +360 1 6.80163 4.43627 5.8851 -3.03056 -0.645399 -10.9559 +361 1 8.29576 5.01058 4.81068 0.626199 13.0736 14.2059 +362 1 1.05047 6.19551 5.02762 -0.156468 -7.32209 -14.0064 +363 1 0.578297 5.15849 5.72641 1.63655 2.26956 0.551951 +364 1 8.23943 6.07268 5.87533 8.87399 -0.526239 1.15285 +365 1 1.76527 5.31835 4.93011 -1.00084 -16.0238 11.4126 +366 1 2.88183 5.91468 5.07925 -22.1885 -17.105 2.25231 +367 1 2.65936 4.93415 6.03537 0.686882 11.6758 -2.90902 +368 1 2.03447 5.84592 5.92534 2.47635 -18.2138 -25.6325 +369 1 3.24392 4.86959 5.11086 62.6624 1.69747 54.073 +370 1 4.07402 5.91621 4.83335 -4.98562 8.578 9.29517 +371 1 3.92826 4.74513 6.11781 2.52773 6.36319 -4.5061 +372 1 3.44964 5.83627 5.89312 16.6713 -3.51566 20.823 +373 1 5.12814 5.53194 4.84592 -22.4422 -5.59515 37.2611 +374 1 5.90308 6.17208 5.1146 -12.9736 21.9443 6.65273 +375 1 5.95357 5.13374 5.81819 6.93561 8.02219 4.14964 +376 1 4.75268 5.76162 5.94655 1.5775 -0.40438 -5.87077 +377 1 6.51586 5.41565 4.90612 17.2134 -26.1979 -1.37429 +378 1 7.5279 5.93793 5.01527 -3.38884 15.9345 -12.1825 +379 1 7.6332 5.21687 5.72128 4.22628 -40.3472 -14.2075 +380 1 6.64022 6.14894 5.87989 13.3598 -6.13205 -0.934618 +381 1 8.34458 6.85129 5.15926 -14.2808 -7.95422 -4.25663 +382 1 0.833911 7.25078 4.85532 9.11386 4.17832 -8.89911 +383 1 1.06673 6.48225 6.01607 -14.203 -6.44505 8.15493 +384 1 -0.0379195 7.65497 5.88016 -1.75378 4.76646 1.63712 +385 1 2.12599 6.69323 4.98422 2.81787 34.3524 37.6883 +386 1 2.84758 7.50703 5.20442 -10.9987 17.1664 -16.5728 +387 1 2.77128 6.71691 5.85642 -9.44911 -10.1768 15.1935 +388 1 1.58013 7.32255 5.72901 16.1676 5.29147 -4.24753 +389 1 3.6768 6.91779 5.33962 13.4611 -20.8664 1.96557 +390 1 4.03881 7.88236 5.22897 2.57592 -0.812644 -11.9679 +391 1 4.4232 6.75921 6.19682 -8.5477 -5.71312 7.44018 +392 1 3.24799 7.72667 6.18249 0.719386 0.220585 -2.48264 +393 1 4.83295 6.89566 5.2507 4.97045 -2.42982 -4.77289 +394 1 5.87897 7.61282 5.14968 -20.2612 -0.49131 -22.7769 +395 1 5.75942 6.67532 6.09541 -7.34504 3.57141 -0.447292 +396 1 5.14318 7.54839 6.30602 2.0724 10.313 -0.219969 +397 1 6.74639 6.92855 5.00696 6.96871 -0.230218 1.29861 +398 1 7.3805 7.8124 5.23875 7.69485 -10.0795 -7.08489 +399 1 7.52596 6.88746 5.90198 -6.42674 1.56965 2.19774 +400 1 6.51888 7.44621 5.87193 29.4637 -7.18826 32.3539 +401 1 8.28476 0.000423359 6.72306 2.02553 19.5279 -19.3713 +402 1 1.01888 0.905848 6.82221 -28.6303 -12.8009 -18.3361 +403 1 1.24262 8.30657 7.44334 -32.4348 0.998186 -42.9826 +404 1 0.0211475 0.824091 7.47144 0.973424 -13.5355 3.24171 +405 1 1.94007 8.12144 6.72811 7.36532 0.254467 -18.2635 +406 1 3.02097 1.5587 6.75498 -16.6323 -17.6578 -2.8331 +407 1 2.39982 0.0370076 7.66598 -2.14889 1.34284 -3.48663 +408 1 1.9688 0.847456 7.09398 30.835 -18.1107 26.5169 +409 1 3.29942 8.17609 7.18194 3.78499 -8.25924 -8.09048 +410 1 3.92844 1.06207 6.75726 8.02723 -15.5891 -9.47025 +411 1 4.52946 0.167766 7.50023 3.36063 -0.839689 -4.02118 +412 1 3.29302 0.728616 7.56048 2.70434 15.6737 2.80228 +413 1 5.10415 0.332413 6.57695 -15.8309 -23.3459 -1.79261 +414 1 5.90656 0.845621 6.88018 -8.12621 13.928 11.6173 +415 1 5.71058 8.18101 7.57391 -10.3063 5.31817 -1.8554 +416 1 4.82988 1.18118 7.265 13.8593 7.32067 6.7543 +417 1 6.57919 8.43785 7.00021 11.8406 5.1504 -4.86933 +418 1 7.5282 0.806752 6.77786 -1.5451 6.42857 5.82496 +419 1 7.48349 8.33572 7.57521 5.34797 11.8467 16.9658 +420 1 6.70557 1.08836 7.47923 9.5713 -7.54062 13.1357 +421 1 0.0382442 1.56126 6.72749 -0.0966071 11.4911 -0.854867 +422 1 0.869187 2.34639 6.83989 -3.61656 -2.89703 1.60294 +423 1 0.999275 1.45672 7.67633 -8.0034 9.48038 5.5647 +424 1 0.139215 2.63275 7.64328 -15.7892 -20.5267 5.19008 +425 1 1.88893 1.53066 6.37684 -7.83006 6.68056 5.79142 +426 1 2.1935 2.73769 6.82665 18.0903 -33.7124 -24.8324 +427 1 2.37018 1.89864 7.50076 -8.8745 -17.5059 -13.2094 +428 1 1.48561 2.41457 7.71452 -8.23366 6.90197 4.22635 +429 1 3.39063 2.48859 6.68098 16.1595 11.6225 -22.1191 +430 1 4.55604 3.04369 6.47522 -16.239 -17.1818 -0.0461326 +431 1 3.92972 1.83682 7.47298 10.0225 0.0134714 -13.9461 +432 1 3.03012 2.73851 7.57823 -7.17652 4.30522 18.5475 +433 1 5.02119 2.07008 6.4546 -13.5258 -22.6225 -4.75661 +434 1 5.65211 2.81921 6.68199 10.7014 16.4385 -2.46135 +435 1 5.81386 1.77715 7.51287 -3.39579 0.139075 -0.667502 +436 1 4.71678 2.54344 7.41951 15.4924 -28.3106 -11.236 +437 1 6.66707 1.83619 6.71865 -2.24275 1.62817 8.66814 +438 1 7.65934 2.42567 6.78337 1.29364 23.1589 -24.9484 +439 1 7.60492 1.76056 7.50233 6.44148 -25.2098 19.19 +440 1 6.42541 2.6971 7.41321 1.20391 11.9169 -7.49803 +441 1 0.132604 3.18129 6.70867 -2.29445 4.14817 -3.79866 +442 1 0.662351 4.17412 6.80772 -12.4952 0.818831 -9.43638 +443 1 0.788837 3.4069 7.65946 13.9586 12.3209 -0.784492 +444 1 8.14087 4.12742 7.481 16.3072 -9.43806 5.16356 +445 1 1.48457 3.42655 6.6105 -23.5819 5.37731 -5.67472 +446 1 2.19532 4.19793 6.62241 18.5812 -12.748 4.0704 +447 1 2.03418 3.35836 7.57671 1.74798 18.3537 22.2752 +448 1 1.46881 4.26381 7.4306 10.5669 6.85755 16.1187 +449 1 3.40116 3.57046 6.96596 -19.5489 -14.8384 -6.51121 +450 1 4.14086 4.23036 7.04697 14.6332 24.1596 -34.0677 +451 1 4.37587 3.46381 7.58097 -0.667569 -11.1793 25.3659 +452 1 3.3081 4.23862 7.84495 3.59222 -23.7983 19.5534 +453 1 5.02719 3.92296 6.55308 10.3874 19.2736 1.42121 +454 1 5.99108 4.37569 6.77029 -42.1869 -21.9594 -11.1356 +455 1 5.60639 3.61515 7.4373 -8.14506 -14.6497 -3.14446 +456 1 5.05417 4.46396 7.7264 -7.96475 -5.84314 -22.6526 +457 1 6.56389 3.51182 6.41915 7.41692 -2.85266 9.06964 +458 1 7.47152 4.32616 6.69237 -6.16955 -7.38805 -5.63513 +459 1 7.53898 3.20716 7.62579 -2.06037 -6.09637 -1.14724 +460 1 6.59589 3.90993 7.45755 23.4751 -0.996001 13.7582 +461 1 8.21483 5.0816 6.83956 12.3265 -1.95746 -0.89439 +462 1 0.465403 5.98278 6.74845 -2.0373 -17.3355 -17.4636 +463 1 0.511394 5.19401 7.82937 -10.2185 -4.74355 -3.50015 +464 1 8.12271 6.05839 7.46163 -7.84524 3.1436 -8.24587 +465 1 1.48514 4.9291 6.5693 -9.22109 4.87392 -22.494 +466 1 2.40623 5.73649 6.97099 14.0591 -30.3418 -0.240996 +467 1 2.41461 4.96776 7.80425 -3.8539 -8.74065 -18.3704 +468 1 1.44923 5.49011 7.41 13.6015 -14.5185 13.7078 +469 1 3.24542 4.75566 7.0008 -15.7357 21.5396 -25.2781 +470 1 4.03587 5.88736 6.84618 18.4928 -13.3364 -12.8531 +471 1 4.10808 5.01612 7.64484 -5.1777 21.728 20.8534 +472 1 3.29694 5.8019 7.54893 0.566822 -11.9233 11.3035 +473 1 4.81889 5.07278 6.77721 5.06549 -4.43332 1.49875 +474 1 5.96641 5.77692 6.72214 -33.9279 46.677 -28.2473 +475 1 5.88193 5.34623 7.60234 -1.49551 -23.3855 17.2998 +476 1 4.83941 5.81133 7.62234 25.0546 -26.9624 -0.550707 +477 1 6.63577 5.08354 6.75153 63.1873 3.33413 5.12133 +478 1 7.44477 5.7383 6.53202 -8.94815 26.2377 30.0386 +479 1 7.45353 4.90407 7.60234 6.61529 10.6464 -15.3985 +480 1 7.05207 6.05238 7.85033 -15.5225 4.97074 -5.49642 +481 1 8.33549 6.95757 6.75022 0.367032 -2.97861 0.255273 +482 1 0.891414 7.50932 6.49478 -4.83629 2.79466 11.3618 +483 1 1.06555 6.40917 7.42656 -9.40876 15.4887 12.6203 +484 1 0.19507 7.80618 7.47535 7.27195 -18.2248 4.26121 +485 1 1.90915 6.5235 6.63557 -10.6214 46.709 18.7487 +486 1 2.60482 7.35009 7.06318 -2.87326 8.86923 -10.12 +487 1 2.54785 6.52686 7.66612 -14.5904 -1.60347 8.59865 +488 1 1.54201 7.28494 7.4147 7.26892 14.9372 -8.95427 +489 1 3.42163 6.7113 6.72693 -9.74068 0.0780566 2.81617 +490 1 4.07503 7.52705 6.85904 11.3718 5.59625 6.13428 +491 1 4.17032 6.5317 7.69612 -24.7224 6.99609 -12.8841 +492 1 3.30541 7.28919 7.8835 -6.45113 3.62128 -9.60987 +493 1 5.18135 6.6767 7.03146 3.30189 -12.2169 -7.11599 +494 1 6.1441 7.48882 6.87735 -8.40006 -9.95553 -2.76953 +495 1 5.99111 6.52776 7.79328 26.4283 6.66779 -19.7705 +496 1 4.88188 7.45813 7.61707 18.1033 18.9899 -14.9739 +497 1 6.70265 6.55612 6.94114 4.37785 1.73726 -4.76735 +498 1 7.52255 7.69097 6.78657 -11.7433 -15.8982 -13.9562 +499 1 7.60662 7.23551 7.85952 12.3776 -11.2962 -9.39843 +500 1 6.63368 7.62048 7.85195 7.88485 3.15928 -11.7162 +ITEM: TIMESTEP +300 +ITEM: NUMBER OF ATOMS +500 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +ITEM: ATOMS id type x y z fx fy fz +1 1 0.233349 8.13006 8.37458 -13.2268 13.2109 8.94155 +2 1 0.896766 0.85308 8.30255 3.22629 3.6978 6.45643 +3 1 0.859864 0.0707018 0.945242 -23.4126 -16.0712 -18.9613 +4 1 0.0588758 0.842768 1.07285 9.62638 -2.91549 -12.4893 +5 1 1.77938 8.21846 0.149185 -27.8434 -16.3109 -1.32989 +6 1 2.24018 0.700289 8.36085 16.269 9.92358 -3.41709 +7 1 2.6315 8.21417 0.711168 13.3859 0.245092 -3.82819 +8 1 1.39092 0.935915 0.985394 12.7346 13.01 -5.10945 +9 1 3.3176 8.39636 8.17869 -11.566 -16.9274 13.6338 +10 1 3.85219 0.815062 0.0370236 10.4004 28.9589 -3.67884 +11 1 4.161 0.0319779 0.627546 1.75904 -7.59281 -2.75644 +12 1 3.11636 0.817642 0.847547 4.80203 -27.6102 -6.44654 +13 1 5.13793 8.3571 8.28888 -5.17208 4.97346 2.0085 +14 1 5.70385 0.905818 8.12031 -17.8373 19.4407 -6.83741 +15 1 5.79877 0.0963845 0.817928 -4.38032 -1.5507 0.666839 +16 1 4.98412 1.21117 0.664665 -21.555 -8.66432 0.346644 +17 1 6.45061 0.296088 8.38812 3.42924 -28.9348 -2.0588 +18 1 7.77702 0.350545 0.295684 -0.731277 11.544 -2.82186 +19 1 7.70462 8.17101 1.16161 -8.03851 17.5755 -13.9844 +20 1 6.86494 0.586624 0.875444 5.58847 2.16197 13.2587 +21 1 0.100678 1.61145 0.0186749 -1.1873 -11.6656 4.66894 +22 1 0.998429 2.3998 8.22988 -7.28085 -4.5005 5.89326 +23 1 0.828996 1.87962 0.867267 -19.2592 -9.93125 -3.90703 +24 1 8.27374 2.4894 0.580898 8.78255 -11.7455 7.53659 +25 1 1.74048 1.62493 8.26739 -9.18296 -12.9889 2.92816 +26 1 2.39558 2.37629 0.0600193 9.87685 24.4855 1.90731 +27 1 2.45445 1.58898 0.877492 -32.2642 -6.64837 2.63885 +28 1 1.65243 2.45558 0.846906 19.966 -6.37675 -0.113589 +29 1 3.02408 1.54485 8.35689 5.59986 -7.64836 -2.85923 +30 1 3.92 2.20197 8.38732 -20.8443 12.2841 2.52306 +31 1 3.77985 1.57027 0.846646 20.9907 13.6119 -1.22324 +32 1 3.10388 2.34584 0.944358 6.32701 23.9593 -3.77688 +33 1 4.85706 1.878 8.25981 8.11354 -3.87323 -9.47245 +34 1 5.78268 2.09333 0.29673 -1.36849 16.4599 4.03726 +35 1 5.97863 1.20376 0.790291 32.0463 2.36619 -11.4383 +36 1 4.88385 2.45634 0.850397 9.78281 -16.7958 -1.62774 +37 1 6.62285 1.61835 8.29579 8.05661 -4.4773 5.02204 +38 1 7.55399 2.56197 8.18132 12.8994 -8.38166 15.4695 +39 1 7.59924 1.47112 0.768275 -0.340381 -2.67871 -5.54587 +40 1 6.74877 2.64386 0.753723 -17.0902 -18.9793 -10.4389 +41 1 8.35722 3.30339 8.29621 3.88209 -7.05803 1.13469 +42 1 0.765977 3.99405 0.477073 10.4517 2.49603 -17.2656 +43 1 0.831221 3.06707 0.900453 -8.35587 -6.78904 7.02328 +44 1 0.140436 4.39767 1.19127 -1.57081 11.5239 1.23833 +45 1 1.55351 3.27393 8.36662 -0.118073 6.26889 7.92677 +46 1 2.48303 4.16731 0.14908 -13.7582 -4.26857 1.92322 +47 1 2.37333 3.17517 1.02067 -14.4692 6.50264 -31.5071 +48 1 1.65701 4.17058 1.15287 -1.5797 -1.97941 -12.8817 +49 1 3.21438 3.21157 0.146996 -20.1594 -11.7694 11.9952 +50 1 4.28321 4.06082 0.235561 -7.01013 0.464645 -7.4456 +51 1 4.00184 2.96868 0.822048 -4.54826 25.7516 -18.5713 +52 1 3.26412 4.08833 0.821613 11.1851 4.36305 6.27367 +53 1 4.93889 3.19103 0.0459746 -2.17639 -1.1271 -7.48927 +54 1 5.93535 4.0528 8.21654 -1.56333 -1.65165 1.96928 +55 1 5.75576 3.15988 0.707778 17.6817 -13.2713 5.13403 +56 1 5.2315 4.02943 0.763223 -0.452475 -6.04463 7.12931 +57 1 6.80967 3.18308 7.98158 -23.2698 3.29018 18.9116 +58 1 7.84937 4.15894 0.139115 -10.2897 11.6744 2.993 +59 1 7.56351 3.24008 0.752033 -0.468845 18.0521 -12.3044 +60 1 6.70326 3.88955 0.624889 -0.941138 0.59008 2.25635 +61 1 0.263315 4.89557 0.260533 -21.3177 5.01328 -15.5704 +62 1 0.767954 5.80979 8.30607 7.59978 -5.84563 1.67074 +63 1 1.01162 5.03409 0.908989 7.54529 2.69929 16.3999 +64 1 8.38725 5.83431 1.00337 3.61589 -4.15339 -6.36164 +65 1 1.65923 4.84747 0.0732901 -12.2718 -7.14452 -1.11973 +66 1 2.34253 5.60198 8.30655 7.91513 22.3685 24.006 +67 1 2.47075 4.92775 0.922768 -5.69599 3.89765 2.66746 +68 1 1.65076 5.8624 1.08155 8.28384 13.1663 -26.7168 +69 1 3.21032 4.96288 0.0718385 6.90275 12.0583 4.83562 +70 1 4.31683 5.81091 8.2445 -6.07106 16.001 24.4162 +71 1 4.0022 5.10933 1.08243 -0.987394 -5.51353 -4.14418 +72 1 3.08952 5.8543 1.08001 20.7019 -13.8856 -23.646 +73 1 5.04193 4.8848 0.236201 -6.75887 8.84809 -11.6728 +74 1 6.01036 5.86922 0.147762 0.616812 -0.708561 -9.8882 +75 1 6.00591 4.76669 0.704892 -5.00399 3.30231 -11.9912 +76 1 5.15986 5.7957 0.727818 -36.1273 9.99449 -4.0864 +77 1 6.87642 4.89744 0.140008 2.16293 1.86546 -13.7103 +78 1 7.84039 5.5603 8.24691 -4.77039 2.45387 6.97935 +79 1 7.61247 4.95216 0.884224 61.5464 5.54866 -31.4574 +80 1 7.13999 5.87097 0.66837 -10.4004 0.446979 -1.0889 +81 1 0.284976 6.68434 0.215945 -19.2498 8.05662 -14.0567 +82 1 0.982876 7.472 8.30358 11.1034 -5.67626 13.795 +83 1 0.874256 6.63686 1.03265 -11.7399 -6.70777 -2.09767 +84 1 0.12523 7.53526 1.06205 -15.5002 -8.52158 -32.9301 +85 1 1.53836 6.56542 0.124336 5.81155 -2.74575 2.70263 +86 1 2.45566 7.24014 0.163939 -13.7862 7.0524 3.90305 +87 1 2.38368 6.64181 1.16489 5.19309 13.0368 -14.4547 +88 1 1.55777 7.42064 0.955187 2.95317 9.919 -9.12596 +89 1 3.26105 6.57879 0.277391 6.19764 -3.88127 -4.29904 +90 1 4.21681 7.50418 8.36589 0.418779 7.33048 -0.673966 +91 1 4.2136 6.71573 0.805769 6.02261 -2.81289 0.798739 +92 1 3.49573 7.57967 0.77094 -13.8185 -15.1907 -22.6007 +93 1 4.97943 6.65519 6.77102e-05 6.49698 2.41559 -0.5205 +94 1 5.78763 7.50739 0.0292034 7.17211 6.93093 1.18788 +95 1 5.70061 6.80412 0.815144 6.83872 -8.02569 -5.22668 +96 1 4.96155 7.64188 0.754906 -1.40971 0.48378 3.60676 +97 1 6.62543 6.75834 0.212141 20.3815 -6.72799 19.0936 +98 1 7.5054 7.54064 0.228699 5.02405 -0.59125 8.31674 +99 1 7.62741 6.7648 0.966544 10.8528 -1.51524 -6.86782 +100 1 6.51764 7.61106 0.794066 -3.58188 15.2202 -2.22905 +101 1 0.0861403 8.39942 1.77523 16.561 5.47177 12.0456 +102 1 0.798241 0.867486 1.90283 5.83429 -6.22483 -1.18959 +103 1 1.01882 8.16093 2.58804 1.69129 37.21 2.68102 +104 1 8.26047 0.933232 2.39213 16.6191 -6.94084 19.3019 +105 1 1.5043 8.31602 1.70005 24.5225 8.22354 6.48742 +106 1 2.3278 0.505699 1.44491 -1.87805 7.24432 12.5632 +107 1 2.30107 0.0675885 2.61736 -2.34035 -25.4089 0.204635 +108 1 1.65389 0.877547 2.65941 -7.28266 6.33447 -16.1438 +109 1 3.50019 8.31721 1.47862 -16.7888 14.1081 10.898 +110 1 4.01956 0.825924 1.54962 -26.8746 12.2857 6.16059 +111 1 4.07538 0.019132 2.44171 -4.87493 0.404402 -2.17065 +112 1 2.869 0.885962 2.4149 5.17917 -2.47967 0.533766 +113 1 4.73464 0.155071 1.4932 30.6868 -26.2406 6.98684 +114 1 5.62968 0.817396 1.64834 -4.04481 -8.77462 16.8173 +115 1 5.66865 0.0141325 2.50366 17.0023 -1.89327 -13.9307 +116 1 4.86842 0.817468 2.42132 32.27 -13.4362 -6.77265 +117 1 6.59541 8.31415 1.73549 -0.21361 15.3936 4.52423 +118 1 7.59767 0.742823 1.6565 -21.3952 4.75735 -8.6823 +119 1 7.60945 8.3635 2.38741 -3.47518 -4.35582 8.08118 +120 1 6.64964 0.766964 2.59458 1.86331 7.94862 -15.7507 +121 1 0.0966564 1.72383 1.66126 -2.3646 2.96568 -2.77323 +122 1 0.838875 2.52792 1.96878 -8.15441 10.7797 -1.95863 +123 1 0.90776 1.65168 2.68747 -10.1162 -2.78056 -2.47535 +124 1 8.34426 2.2614 2.55151 21.19 -10.0612 15.2043 +125 1 1.46427 1.72978 1.76157 8.28796 -9.22695 -3.48387 +126 1 2.37501 2.29161 1.76614 -0.0664736 7.90276 1.49641 +127 1 2.67166 1.85508 2.81423 -4.33867 8.71682 -6.36279 +128 1 1.69129 2.40006 2.69001 -6.84808 74.503 -77.1336 +129 1 3.2606 1.69371 1.92128 -6.02725 -3.6159 -16.3817 +130 1 3.94104 2.38885 1.63591 5.99851 11.0997 18.049 +131 1 4.04449 1.32304 2.52718 -28.9333 17.8748 13.0885 +132 1 3.64404 2.34301 2.71879 -4.29604 2.09188 -4.97764 +133 1 4.64091 1.6418 1.58405 19.1918 -0.189122 5.88078 +134 1 5.88395 2.31133 1.52544 0.0797298 5.40617 -9.4435 +135 1 5.7987 1.64961 2.35436 -3.46325 -3.79932 12.9903 +136 1 4.78244 2.22308 2.51874 2.01011 -1.75623 -4.81914 +137 1 6.65439 1.55727 1.69251 0.0481382 -10.7878 -2.86985 +138 1 7.4609 2.22018 1.51079 9.36137 15.4008 -1.67913 +139 1 7.50576 1.63853 2.4128 -2.97032 -17.2864 -0.621812 +140 1 6.87214 2.43415 2.42038 -30.5876 3.19651 2.74052 +141 1 8.27498 3.12542 1.46263 16.9155 1.32854 13.6822 +142 1 0.778659 3.95642 1.86807 -7.25106 -12.2522 -5.40095 +143 1 0.798965 3.10856 2.99966 -8.51883 26.4353 -21.6316 +144 1 8.39629 3.85082 2.58225 -5.99614 1.48776 4.40527 +145 1 1.68381 3.21805 1.79101 -5.77633 -5.0861 7.47296 +146 1 2.56903 4.03114 1.71918 -6.92524 18.9919 2.42009 +147 1 2.68821 3.054 2.58052 -0.955464 -0.812242 -0.180548 +148 1 1.68992 4.20726 2.20027 5.368 3.11181 32.2719 +149 1 3.19042 3.29104 1.54336 50.4233 -29.9172 14.5641 +150 1 4.30208 4.0236 1.30142 -3.92395 -1.77865 11.4065 +151 1 4.28898 3.18994 2.59219 8.96711 6.3942 -10.7611 +152 1 3.60727 4.0096 2.21837 0.742083 4.13896 4.48687 +153 1 5.11886 3.09922 1.66619 -2.87182 6.36609 5.71268 +154 1 5.98984 4.3721 1.6574 7.23512 -22.1503 15.9695 +155 1 6.06757 3.38048 2.48886 -0.631751 -1.09061 1.54872 +156 1 5.04095 4.05582 2.29794 7.98224 -6.57422 -3.38111 +157 1 6.80585 3.23363 1.61955 1.81547 4.43083 5.90353 +158 1 7.6107 4.12271 1.4985 -13.6918 -18.0547 7.51636 +159 1 7.71076 3.00605 2.3508 1.14441 21.4666 -12.0177 +160 1 6.92831 4.10176 2.31565 -3.92153 2.58619 4.8482 +161 1 8.33973 5.1724 2.08404 -22.306 -14.8391 -35.8531 +162 1 0.860537 5.83051 1.79504 -25.5953 10.3696 1.23396 +163 1 0.802813 4.96181 2.52052 20.0549 -14.1798 16.2425 +164 1 8.20479 5.88748 2.7573 8.86056 43.8975 -14.7096 +165 1 1.62556 5.15881 1.79421 13.6671 -60.0224 -43.8322 +166 1 2.44832 5.82052 1.83706 -21.0979 -8.85922 15.9808 +167 1 2.35829 4.95884 2.60055 5.56499 -3.25718 -17.7316 +168 1 1.57047 5.68188 2.57793 3.26945 48.3874 60.3367 +169 1 3.12962 4.94115 1.79611 3.44797 3.66295 -7.67081 +170 1 4.533 5.88518 1.61818 -3.82507 3.84853 0.541056 +171 1 4.41047 4.91386 2.27111 -7.04817 9.97354 -0.554451 +172 1 3.1705 5.97206 2.56867 13.8835 0.36015 7.54685 +173 1 5.10201 4.84379 1.45925 -8.99072 13.7146 -7.42642 +174 1 6.04077 5.71462 1.17105 24.8221 7.94918 20.2395 +175 1 6.02655 5.34395 2.16117 8.67798 2.32994 -0.236737 +176 1 5.13754 6.13757 2.45889 -19.0768 2.88926 -22.199 +177 1 6.81157 4.98564 1.3948 -36.2833 4.79272 33.0954 +178 1 7.60086 5.99469 1.7372 -3.24829 -8.45789 -2.93345 +179 1 7.33283 5.34101 2.57932 2.07328 -12.097 -6.46632 +180 1 6.77196 6.24125 2.34214 -17.3674 -5.70799 13.1243 +181 1 0.0250537 6.6606 1.72753 8.49396 4.93702 8.33356 +182 1 0.795762 7.59079 1.77266 12.7999 -27.3678 15.1487 +183 1 0.926657 6.70523 2.69571 -0.793657 3.91691 -3.18748 +184 1 0.160908 7.59778 2.74546 -5.44053 4.97464 -19.9661 +185 1 1.54893 6.69469 1.77147 8.37496 4.15768 30.0144 +186 1 2.38553 7.66265 1.59156 1.85092 -2.31642 6.75994 +187 1 2.52893 6.74213 2.34554 9.20138 12.1517 -25.6716 +188 1 1.80175 7.4451 2.61158 -6.78811 17.5009 -13.1399 +189 1 3.38458 6.74038 1.57533 -10.1646 -3.59545 3.61897 +190 1 4.095 7.47851 1.58866 27.0187 15.4009 2.51878 +191 1 4.11379 6.83 2.37783 19.5598 -18.1657 -14.1463 +192 1 3.12959 7.71074 2.36405 10.6634 -2.49932 -15.2866 +193 1 5.08729 6.94297 1.62592 -21.1801 -24.4484 5.07107 +194 1 5.73581 7.71377 1.57745 5.16642 11.3097 -0.890489 +195 1 5.92001 7.08484 2.45291 -0.193261 -0.933403 -1.70059 +196 1 4.83819 7.59024 2.39768 8.18574 14.9342 11.0206 +197 1 6.61545 6.66525 1.38958 -18.6406 -25.8802 -11.2439 +198 1 7.15994 7.45994 1.57935 11.6501 4.19084 33.778 +199 1 7.56748 6.9114 2.40976 10.0926 4.81165 9.43494 +200 1 6.80428 7.72449 2.78938 -1.24224 -1.60677 -10.8659 +201 1 0.159784 0.136544 3.24366 -1.32953 4.05967 1.66335 +202 1 1.00698 0.811307 3.51207 1.50245 1.78035 6.01503 +203 1 1.34713 0.12551 4.66914 -24.521 -31.0514 3.16868 +204 1 0.0655245 0.668593 4.25847 -0.855275 2.59789 -3.35749 +205 1 1.74942 8.37675 3.57933 -10.207 -16.1779 -1.21978 +206 1 2.26863 0.82911 3.48792 22.6881 17.8048 9.09595 +207 1 2.33553 0.183914 4.4711 16.8323 -1.13179 -15.08 +208 1 1.7049 1.03332 4.4695 6.78822 33.3459 -7.07653 +209 1 3.29237 0.411287 3.32326 -2.12858 -4.79866 -0.866625 +210 1 4.21141 0.796867 3.72276 15.2258 15.2508 -15.0202 +211 1 4.33441 8.33993 4.30342 13.6521 7.25398 3.1725 +212 1 3.45786 0.725922 4.42039 -13.4693 -6.1715 4.46767 +213 1 4.89231 0.0473082 3.15782 -6.25621 1.30634 20.3282 +214 1 5.77362 0.736119 3.37748 -9.09312 1.23928 -13.4649 +215 1 5.99071 8.04065 4.47949 -15.8189 13.2428 -8.46949 +216 1 5.196 0.682234 4.2587 4.7081 -6.90451 -0.266688 +217 1 6.57106 0.145322 3.40637 19.3462 -23.2913 17.9258 +218 1 7.59401 0.663732 3.46257 -2.8602 2.11131 -2.24016 +219 1 7.44242 8.25412 4.2449 1.11307 19.9225 9.74876 +220 1 6.62382 0.709572 4.35284 3.66026 3.16927 -3.64727 +221 1 0.0779483 1.38159 3.37319 -4.4953 5.38733 3.01304 +222 1 0.974278 2.30233 3.53228 -23.5961 -13.9704 29.7447 +223 1 0.524182 1.77379 4.53785 8.44119 -12.0369 -19.76 +224 1 8.32657 2.54461 4.19453 11.685 -8.01921 4.29442 +225 1 1.79699 1.78778 3.36592 20.9053 -94.2146 75.3552 +226 1 2.26904 2.65097 3.69138 3.64635 0.74501 -3.21688 +227 1 2.67429 1.70202 4.43144 -1.62218 -6.52331 -3.16444 +228 1 1.67869 2.25152 4.52595 21.8057 -26.9163 -24.6655 +229 1 3.42529 1.64095 3.50559 7.24234 -14.969 7.63922 +230 1 4.36843 2.51227 3.48596 2.07064 -5.87084 11.4812 +231 1 4.83369 1.71242 4.31187 -12.4342 -5.24453 -2.55025 +232 1 3.42697 2.55135 4.03879 13.1661 -11.4647 -6.22039 +233 1 5.09889 1.5127 3.30322 -10.1348 7.40169 -7.59726 +234 1 6.05204 2.45182 3.35855 -5.34479 4.21286 -4.99107 +235 1 5.91247 1.54121 4.03978 -1.19872 3.24833 9.47786 +236 1 5.34566 2.59829 4.30389 3.31953 7.26855 -16.7286 +237 1 6.74657 1.65018 3.27179 -23.12 -29.0051 -3.67746 +238 1 7.53263 2.23686 3.30386 26.344 22.8452 7.39879 +239 1 7.49613 1.58204 4.21155 10.9589 -18.8504 -4.35663 +240 1 6.70452 2.2326 4.19472 -13.7578 19.073 -7.70781 +241 1 8.04948 3.18864 3.48276 7.81989 17.0755 -15.6642 +242 1 0.420364 4.02026 3.62891 2.0762 -18.0048 -13.8871 +243 1 1.02911 3.20723 4.10028 2.87528 5.61338 3.46722 +244 1 8.23518 4.59996 4.24867 -9.72892 -14.3069 11.6196 +245 1 1.79813 3.62221 3.14835 -2.38332 -26.1643 0.00682256 +246 1 2.74246 4.09054 3.06778 10.2172 -0.241531 -5.01738 +247 1 2.65108 3.56469 4.0066 1.29528 2.95166 -0.450344 +248 1 1.68753 4.16642 4.41008 0.531244 0.36282 -0.905409 +249 1 3.56157 3.26659 3.34031 -15.156 16.0178 -13.2173 +250 1 4.30786 4.20161 3.07587 -3.71718 9.6458 -20.0534 +251 1 4.29173 3.71129 3.93288 2.63232 -25.6185 20.4798 +252 1 3.34785 4.41255 3.95574 4.30294 0.337698 1.30747 +253 1 5.19196 3.15058 3.27975 2.68017 7.34728 -0.723223 +254 1 6.11836 4.37563 3.09786 3.48097 -0.455645 -7.15348 +255 1 6.16379 3.4966 3.8024 -0.493793 0.0328113 2.1336 +256 1 5.30251 4.52711 3.80393 -16.2632 -25.1941 -0.0075048 +257 1 7.08947 3.30091 3.10932 -23.6486 5.19633 4.56168 +258 1 7.44697 4.43668 3.27896 -0.511887 -2.93371 -0.292771 +259 1 7.26132 3.68038 4.11877 19.5278 5.77559 -31.2062 +260 1 6.65227 4.59556 4.02535 -2.98634 0.729124 1.77093 +261 1 8.32438 5.07972 3.31456 7.45197 -18.3523 8.49382 +262 1 0.7239 5.87238 3.35063 13.9037 -7.68163 -11.6827 +263 1 0.86133 4.86733 4.0112 5.23908 17.06 9.33784 +264 1 0.110376 5.99228 4.15088 -19.5006 -5.14624 15.1727 +265 1 1.63326 4.60922 3.31023 -1.76723 17.8491 2.08855 +266 1 2.40135 5.61695 3.38494 19.4662 4.44663 -11.3673 +267 1 2.36184 5.08435 4.31966 -1.81965 -14.9274 -8.60789 +268 1 1.71701 5.94552 4.03684 -24.0402 -0.0953197 5.79012 +269 1 3.43912 4.9954 2.79577 7.89838 -10.7079 17.2388 +270 1 4.22838 5.86109 3.02821 33.6181 3.37383 -45.0173 +271 1 4.24887 5.06359 3.71273 2.64953 -0.546445 2.15952 +272 1 3.55742 5.92395 3.71083 -38.5919 -3.44905 39.4056 +273 1 5.41837 5.23828 2.98577 -11.447 -4.74628 10.7983 +274 1 5.86494 6.22754 3.11739 14.9731 7.40151 22.8162 +275 1 5.75467 5.37436 4.08221 13.6205 23.921 6.83069 +276 1 4.77382 6.13694 3.95439 -2.74813 -13.8938 10.4295 +277 1 6.55906 5.4789 3.24844 0.234698 -8.05013 11.4476 +278 1 7.53331 6.151 3.48116 -10.0459 9.16913 -20.7264 +279 1 7.59712 5.40949 4.12314 -10.2706 -23.4933 17.211 +280 1 6.76315 6.15422 4.20451 -8.32818 -2.13306 4.306 +281 1 8.33074 6.79274 3.30017 10.9969 -9.86444 14.3566 +282 1 1.03943 7.60681 3.41422 12.8839 -22.0033 7.43641 +283 1 0.876997 6.68124 4.1033 12.4942 12.9257 -7.86127 +284 1 0.320289 7.62896 4.11358 -19.9566 8.93301 7.64028 +285 1 2.12233 6.73507 3.25947 -6.36672 -13.9408 34.1069 +286 1 2.9278 7.71082 3.35699 -9.10575 13.9767 3.53664 +287 1 2.86555 6.96099 4.04549 -8.29151 -16.9355 4.68952 +288 1 1.89553 7.49272 4.25249 -6.95602 2.25366 -4.36835 +289 1 3.55128 6.82828 3.17739 -22.1877 4.18931 17.356 +290 1 4.1661 7.71123 3.4095 -5.10369 -4.69259 -0.796458 +291 1 3.89274 6.87937 4.19693 15.4298 1.82254 7.44647 +292 1 3.39266 7.95134 4.30177 -1.7872 -21.2114 -27.9517 +293 1 4.99714 6.86548 3.27273 -3.15325 15.5146 -9.80269 +294 1 5.7604 7.67976 3.37293 2.05238 1.22428 3.6757 +295 1 5.73479 6.76996 4.15088 6.33474 -4.66485 -1.392 +296 1 5.07616 7.57695 4.40446 -13.6351 -7.42167 0.514113 +297 1 6.73778 6.81794 3.33301 -3.54485 0.402493 -5.08336 +298 1 7.71498 7.67053 3.44695 -0.752689 -3.6099 -11.6949 +299 1 7.71759 6.87965 4.22182 -5.11403 5.07303 3.22293 +300 1 6.7649 7.45476 4.17956 6.56157 -12.3801 -0.724651 +301 1 8.19197 0.136233 5.17288 2.67067 20.6746 -19.9914 +302 1 0.776102 0.931351 5.08619 -1.70464 -8.91233 1.85235 +303 1 0.888781 0.0179834 5.65999 -4.55543 21.0031 13.534 +304 1 8.38466 0.737331 6.00004 -6.63761 5.81892 -3.68334 +305 1 2.17326 8.16764 5.48567 -30.0571 8.40977 9.50779 +306 1 2.68565 0.975823 5.34104 11.1467 5.8174 -19.2362 +307 1 3.06444 0.336871 6.1128 1.74673 -5.08128 15.5867 +308 1 1.94778 0.751629 6.0231 -12.5402 -6.77103 11.9096 +309 1 3.09215 -0.0018856 5.12048 23.3711 9.80891 31.3016 +310 1 4.54285 0.96074 5.03055 -10.8439 -8.47943 8.00065 +311 1 4.19772 8.25187 6.2874 -2.87662 7.25597 -11.3947 +312 1 3.73883 1.45482 5.73884 -5.31372 -3.16529 -7.8226 +313 1 5.15615 8.35466 5.42348 2.42368 -1.79965 -6.24325 +314 1 5.91471 0.891384 5.15303 -5.07011 -3.09253 -0.460458 +315 1 6.03745 8.35632 6.14961 -1.39208 3.8678 -5.18235 +316 1 5.2121 0.86593 5.98804 -13.8254 0.446509 -12.536 +317 1 6.68868 8.34181 5.14194 3.9888 6.48649 16.9974 +318 1 7.34021 0.809849 5.26372 -2.78853 -11.1974 -10.3326 +319 1 7.36245 8.30575 6.05369 1.98185 25.0408 -10.0092 +320 1 6.64158 0.85851 5.99168 -3.68623 1.19752 6.36998 +321 1 8.13309 1.40671 5.10096 17.8835 4.45702 -4.02515 +322 1 0.892662 2.59499 5.00421 -20.8235 21.437 24.4928 +323 1 0.773043 1.57142 5.91415 4.22614 9.86073 2.56515 +324 1 8.33239 2.57823 5.60038 -0.623629 0.0892147 1.2306 +325 1 1.87225 1.66498 5.43985 -2.48264 -4.0236 -4.58226 +326 1 2.75473 2.72259 4.73435 -30.311 11.1987 -1.55273 +327 1 2.93165 2.12687 5.49641 -1.73472 -35.7803 16.6222 +328 1 1.7335 2.58373 5.90704 -3.71318 12.7214 1.30751 +329 1 3.77896 1.69526 4.65032 1.63977 11.6216 2.36832 +330 1 4.33882 2.78478 4.62298 7.45227 7.00188 -24.1667 +331 1 4.0935 2.44339 5.52545 -11.3615 -7.17888 20.8862 +332 1 3.18285 3.03749 5.86709 11.7107 14.2608 -10.1303 +333 1 5.16253 1.77254 5.33362 4.38648 8.73211 2.03951 +334 1 5.9743 2.78241 5.0854 16.8461 0.569184 7.37091 +335 1 6.05449 1.8557 6.00418 -1.07841 -2.85482 0.754485 +336 1 5.02736 2.93607 5.49369 -0.394928 -5.32288 -0.0457358 +337 1 6.65738 1.68333 5.09298 2.04945 -3.50949 1.46808 +338 1 7.506 2.4535 4.81544 -2.36267 6.50792 21.426 +339 1 7.5049 1.81157 5.81254 2.0705 -7.66144 9.63716 +340 1 6.81799 2.57614 5.74327 -5.22025 12.4071 0.584392 +341 1 8.08209 3.4329 4.82809 -0.388102 0.733533 -0.302449 +342 1 0.687603 4.05264 4.91973 13.3113 7.10483 -26.1293 +343 1 0.927182 3.40713 5.70883 1.42 -2.21252 8.41121 +344 1 8.39125 4.08596 5.64374 -17.7983 3.69834 21.9629 +345 1 1.85335 3.18328 4.91159 -22.5662 10.1648 8.61749 +346 1 2.62594 3.83741 5.0269 -11.5374 29.2389 12.1219 +347 1 2.23001 3.64598 5.99431 12.2251 -19.0314 6.6066 +348 1 1.61612 4.36322 5.62412 -4.72812 -41.6645 3.65456 +349 1 3.49026 3.4159 4.80384 34.5623 1.92174 -9.26957 +350 1 4.42781 4.48169 4.58587 2.89283 12.0072 14.2383 +351 1 4.32987 3.73273 5.40213 -1.15236 0.923586 4.29704 +352 1 3.35747 3.99106 6.24745 4.6285 19.5949 -5.94829 +353 1 5.1733 3.66262 4.57851 -0.760359 -3.40804 -5.73178 +354 1 5.75745 4.60154 4.93992 12.48 38.3619 -39.183 +355 1 5.60952 3.84508 5.51193 1.72033 -36.6996 37.1733 +356 1 4.90838 4.64872 5.58962 -7.33472 10.9707 -1.22542 +357 1 6.81366 3.55073 4.97382 -24.7572 -16.3635 34.7513 +358 1 7.36231 4.42367 5.08055 17.1166 2.62568 -2.95463 +359 1 7.4725 3.41969 5.92572 4.71216 -0.444272 -3.67252 +360 1 6.56495 4.37474 5.82163 -0.033274 -9.82017 -6.2351 +361 1 0.041011 5.18659 5.08838 -22.5443 6.51501 -27.8507 +362 1 1.02655 6.1046 4.9959 -2.55187 -8.42255 -9.06362 +363 1 0.725543 4.91454 5.73466 12.2313 -2.94426 20.5318 +364 1 0.0422288 5.86356 5.87032 0.0942915 12.4442 -1.56822 +365 1 1.61098 5.19782 5.1268 2.44581 33.2387 -21.9348 +366 1 2.65636 5.69092 5.09384 11.8609 0.215073 14.2086 +367 1 2.6104 4.85981 5.98721 5.66035 -5.70161 -4.77737 +368 1 1.90538 6.1737 5.70769 -41.2624 -24.39 16.3086 +369 1 3.46858 4.77582 5.16944 -0.707582 -1.43422 0.766057 +370 1 3.76426 5.90532 4.89181 3.4437 -1.11423 -2.15979 +371 1 4.07073 4.92867 6.32743 11.4607 -11.4553 -4.32634 +372 1 3.67793 5.86643 6.05942 -4.35866 5.03724 -1.47182 +373 1 4.98792 5.51389 4.93524 -8.4187 -10.8933 -4.11136 +374 1 5.89023 6.01641 5.05179 11.0493 7.97987 -0.316877 +375 1 5.84913 5.21289 5.8287 7.09495 5.60009 -11.1489 +376 1 4.95887 5.92462 6.03819 -1.41241 -1.47294 -8.90972 +377 1 6.72618 5.24569 4.87739 -4.6501 10.2679 6.06598 +378 1 7.69701 6.07801 4.9728 1.45309 -5.4044 1.15049 +379 1 7.57443 5.25318 5.8022 -4.19719 -6.86637 2.5693 +380 1 6.75672 5.96198 5.84181 4.25859 -4.73277 0.116077 +381 1 0.149236 6.9327 4.88187 0.301354 -7.8021 16.5737 +382 1 1.06612 7.54377 5.19235 6.17987 -18.0682 -12.1896 +383 1 0.908663 6.67909 5.83913 1.89859 7.5565 8.00921 +384 1 8.3967 7.73373 5.73713 17.5958 -22.201 25.7152 +385 1 2.09262 6.53099 4.7967 1.84262 19.7267 -15.5304 +386 1 2.6809 7.4184 4.97144 1.84587 -3.02643 6.66108 +387 1 2.76451 6.5131 6.02372 26.4927 9.3308 7.09081 +388 1 1.89235 7.21971 6.07993 -5.61302 23.442 -46.1583 +389 1 3.56452 6.91614 5.29782 1.29026 -2.451 2.37678 +390 1 4.22056 7.80764 5.23329 -2.48711 -3.82055 1.83806 +391 1 4.29263 6.77471 6.12925 7.35038 5.5119 -5.7056 +392 1 2.85273 7.60961 6.07343 16.4578 1.27697 -7.39815 +393 1 4.81773 6.56695 4.97715 -1.40117 8.33727 3.10183 +394 1 5.78811 7.39325 5.43254 7.66799 3.74746 -17.7564 +395 1 5.91597 6.55237 6.07292 -10.3134 0.875812 3.19143 +396 1 5.1536 7.54901 6.2302 -8.62748 1.72241 13.4381 +397 1 6.84976 6.76387 5.09828 -3.19969 2.83039 -4.79256 +398 1 7.54117 7.72913 5.1763 -12.4453 -25.3207 -11.2598 +399 1 7.70324 6.72981 5.83369 -19.5261 3.79708 -10.3274 +400 1 6.77336 7.41197 5.93794 -9.93531 -0.946567 -12.2979 +401 1 8.22949 8.35705 6.76928 1.64244 -1.45449 1.77988 +402 1 0.72004 0.832942 6.72959 22.4465 -5.361 -6.29847 +403 1 0.883022 0.0931191 7.57241 -5.23405 -15.4407 -5.32038 +404 1 0.0468789 0.82113 7.48906 -16.6351 2.71194 14.972 +405 1 2.03902 8.21121 6.63645 7.11775 -8.1199 -7.72414 +406 1 2.8098 1.35985 6.35749 11.4457 2.58538 -2.95276 +407 1 2.39096 8.06897 7.6788 1.19633 7.68608 5.18448 +408 1 1.75996 0.580686 7.28683 6.89284 15.6237 4.36189 +409 1 3.24708 7.93738 6.98795 5.84043 19.9452 -24.3758 +410 1 4.23919 0.919929 6.46503 -1.07654 -9.91612 -5.08402 +411 1 3.90772 0.424381 7.41946 37.0812 -23.6824 -3.45202 +412 1 2.91871 0.505987 7.33506 -26.0302 7.74114 -11.0468 +413 1 4.92803 0.11282 7.09764 -8.28234 1.33652 -4.84063 +414 1 5.89475 1.0043 6.70526 7.29393 0.830325 27.9656 +415 1 5.8956 8.35718 7.44426 -3.02776 0.024361 13.8614 +416 1 4.71342 1.28665 7.29701 10.263 5.35948 11.5905 +417 1 6.8248 0.0574117 7.01961 11.7828 1.29904 -9.90689 +418 1 7.52034 1.04303 6.65362 -4.17639 -6.17679 3.43381 +419 1 7.73603 8.17986 7.79994 1.7859 4.36245 -17.9939 +420 1 7.13318 0.752429 7.78463 13.3591 3.5282 -5.71599 +421 1 8.39243 1.66394 6.67161 -0.134672 7.39125 4.10576 +422 1 0.854509 2.49412 6.65204 0.887161 -2.38052 0.586225 +423 1 1.18138 1.63924 7.31791 -41.6971 -18.352 25.0151 +424 1 0.0943458 2.334 7.66786 0.324396 10.57 -15.5201 +425 1 1.87867 1.74452 6.645 -1.95754 3.46436 -44.2754 +426 1 2.63684 2.47303 6.52845 -8.45632 -20.7999 4.28943 +427 1 2.51699 1.47554 7.37579 1.92109 3.65888 22.6814 +428 1 1.82876 2.39767 7.50566 14.4123 21.9409 0.136363 +429 1 3.78398 2.21463 6.57246 -2.68631 2.13236 -0.792617 +430 1 4.46308 3.07592 6.43555 -3.89191 7.33892 -9.13636 +431 1 3.59875 1.35397 7.20413 -9.98874 22.9069 2.08665 +432 1 3.19396 2.3577 7.56493 -2.6719 3.09783 -0.16421 +433 1 5.06299 2.1644 6.37533 -2.58633 -2.00836 2.79809 +434 1 5.67119 3.15784 6.34996 -0.566548 -6.83481 -5.10746 +435 1 5.66575 1.97666 7.57441 -14.7077 -20.3342 4.08546 +436 1 4.67442 2.64884 7.36908 -6.67424 -36.8328 0.644107 +437 1 6.68154 1.59605 7.24042 -18.9747 -1.14386 -19.0037 +438 1 7.52504 2.47849 6.70825 -1.30537 -8.16455 -5.2397 +439 1 7.60687 1.7083 7.61907 22.0172 -9.53549 -2.5479 +440 1 6.29708 2.66318 7.23348 12.1765 11.0009 -15.9537 +441 1 0.116615 3.32613 6.70965 -8.35482 -2.36763 -31.1169 +442 1 0.754871 4.30259 6.64315 -6.49201 3.33528 -9.76479 +443 1 0.673999 3.30917 7.54182 21.55 -11.008 11.6004 +444 1 8.2904 4.07274 7.4316 9.5379 25.3171 7.28976 +445 1 1.3832 3.4915 6.68441 -1.24784 -22.5622 2.29536 +446 1 2.09272 4.19927 6.89939 7.14914 10.3433 -0.646722 +447 1 2.38812 3.48925 7.75082 -1.53849 -4.15299 -0.56146 +448 1 0.98545 4.31304 7.66307 5.8465 7.34467 12.6645 +449 1 3.01955 3.30623 6.95327 13.2113 8.86686 7.49164 +450 1 4.09943 3.91395 7.09298 -2.48303 5.76893 1.33505 +451 1 4.01094 3.20608 7.89765 -2.70921 2.34384 1.12391 +452 1 3.37728 4.06259 7.97546 3.1883 6.31048 -16.9835 +453 1 4.95274 4.06193 6.44472 -50.262 -12.0969 -14.4258 +454 1 5.82886 4.19415 6.78586 51.8922 14.3443 21.8961 +455 1 5.38346 3.34165 7.34475 16.015 22.8896 8.36611 +456 1 5.08561 4.4601 7.63447 17.0994 -9.93497 -11.4722 +457 1 6.63523 3.51978 6.68288 11.156 -6.22589 -13.2585 +458 1 7.56324 4.26511 6.59456 -1.25309 2.63878 0.745103 +459 1 7.65852 3.28844 7.34661 -10.7372 -4.25374 3.64969 +460 1 6.81691 4.07739 7.53042 5.20496 31.087 -1.8792 +461 1 0.0305913 5.07954 6.63961 -13.4152 -0.334577 -15.0347 +462 1 0.755373 5.9128 6.63716 6.29428 -4.8245 9.83099 +463 1 0.228688 5.17338 7.63443 6.77209 -15.3569 2.77515 +464 1 0.0239769 6.1789 7.50959 5.71025 13.0173 8.45368 +465 1 1.62736 5.16876 6.26262 -1.95267 15.3222 16.2267 +466 1 2.58882 5.57631 6.81228 -21.3734 15.7914 -12.1527 +467 1 2.44828 4.86387 7.63128 0.635145 -14.9061 -0.714387 +468 1 1.59901 5.57209 7.51534 -11.1496 -3.28487 -5.03165 +469 1 3.34619 4.96263 7.08932 17.4571 -30.3367 -0.525226 +470 1 4.2543 5.71212 7.1129 9.72931 3.13017 -7.54215 +471 1 4.20945 4.90695 7.86069 -23.7666 -21.5851 -7.20856 +472 1 3.30097 5.87496 7.52978 -1.62077 18.6793 20.7743 +473 1 5.31869 5.1825 6.70313 -6.70115 -5.30598 20.424 +474 1 6.1285 5.9705 7.04356 -55.8752 -30.7828 -22.045 +475 1 6.19989 5.01385 7.64593 -24.2843 -27.8512 -0.0723503 +476 1 5.23737 5.71302 7.75618 7.88564 -2.82129 -5.95862 +477 1 6.57282 5.00818 6.64579 3.73801 7.56977 2.57742 +478 1 7.65968 6.07456 6.846 -10.6673 -6.72159 -16.2973 +479 1 7.41458 5.08419 7.34751 2.79575 -2.58892 1.26995 +480 1 6.72257 5.83109 7.80136 50.7146 16.6992 29.5346 +481 1 0.0723308 6.76891 6.47705 11.6111 8.10298 22.8191 +482 1 1.02933 7.74537 6.50218 -6.26193 -3.88943 1.15511 +483 1 0.947055 6.70337 7.58592 -5.51835 -14.0139 4.24362 +484 1 0.0848928 7.36532 7.45176 -1.87156 3.22591 1.0451 +485 1 1.56902 6.60766 6.76327 -14.013 -31.9293 15.0177 +486 1 2.40361 7.17234 6.95829 30.5527 12.991 8.35655 +487 1 2.29885 6.36291 7.58786 1.80834 5.53646 4.44151 +488 1 1.553 7.54602 7.43994 -8.27629 2.11355 -7.51923 +489 1 3.47111 6.73135 6.78593 -6.0772 1.66346 11.0677 +490 1 4.24975 7.49747 6.97664 2.8759 -9.15152 10.7243 +491 1 4.10179 6.68273 7.72108 -3.71491 1.8557 -11.1514 +492 1 3.18945 7.41445 7.81539 11.7129 -34.8369 22.2868 +493 1 5.09069 6.56162 6.92242 0.709322 1.72009 4.70344 +494 1 6.15914 7.53992 6.80488 -4.25562 -6.4834 8.29409 +495 1 6.17817 6.79535 7.72789 -19.4606 -0.130997 -26.8387 +496 1 5.10104 7.47088 7.65047 -2.76834 -2.47532 -11.4779 +497 1 6.74018 6.65599 6.74814 32.1985 25.9827 -14.7809 +498 1 7.41102 7.54832 6.72723 12.7336 -14.2037 26.5422 +499 1 7.28837 6.72521 7.66327 11.2322 2.95469 4.78999 +500 1 6.81386 7.67069 7.84231 -16.9841 5.08288 -4.95949 diff --git a/examples/mdi/dump.17Jun22.snapshot.driver.mpi.1 b/examples/mdi/dump.17Jun22.snapshot.driver.mpi.1 new file mode 100644 index 0000000000..c4ee904680 --- /dev/null +++ b/examples/mdi/dump.17Jun22.snapshot.driver.mpi.1 @@ -0,0 +1,2036 @@ +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +500 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +ITEM: ATOMS id type x y z f_2[1] f_2[2] f_2[3] +1 1 0 0 0 -1.06581e-14 -1.06581e-14 -1.00753e-14 +2 1 0.839798 0.839798 0 2.66454e-15 3.34455e-15 -9.76996e-15 +3 1 0.839798 0 0.839798 2.66454e-15 -1.05471e-14 4.56579e-15 +4 1 0 0.839798 0.839798 -1.15463e-14 2.88658e-15 3.44169e-15 +5 1 1.6796 0 0 -4.09395e-16 -9.76996e-15 -1.04361e-14 +6 1 2.51939 0.839798 0 -4.23273e-16 2.66454e-15 -1.06581e-14 +7 1 2.51939 0 0.839798 -7.00828e-16 -1.06581e-14 2.9976e-15 +8 1 1.6796 0.839798 0.839798 -4.3715e-16 3.10862e-15 3.1225e-15 +9 1 3.35919 0 0 1.28439e-14 -1.06581e-14 -1.04361e-14 +10 1 4.19899 0.839798 0 -2.25236e-14 2.66454e-15 -7.99361e-15 +11 1 4.19899 0 0.839798 -2.34118e-14 -8.88178e-15 2.55351e-15 +12 1 3.35919 0.839798 0.839798 1.37182e-14 3.10862e-15 4.23273e-15 +13 1 5.03879 0 0 2.77556e-17 -7.99361e-15 -7.99361e-15 +14 1 5.87859 0.839798 0 2.26555e-14 2.66454e-15 -7.99361e-15 +15 1 5.87859 0 0.839798 2.16702e-14 -7.99361e-15 2.66454e-15 +16 1 5.03879 0.839798 0.839798 -4.09395e-16 2.88658e-15 2.90046e-15 +17 1 6.71838 0 0 -3.33067e-15 -9.63118e-15 -9.74221e-15 +18 1 7.55818 0.839798 0 4.44089e-16 2.55351e-15 -9.32587e-15 +19 1 7.55818 0 0.839798 0 -1.02141e-14 3.21965e-15 +20 1 6.71838 0.839798 0.839798 -2.94209e-15 2.90046e-15 4.02456e-15 +21 1 0 1.6796 0 -1.15463e-14 0 -1.04361e-14 +22 1 0.839798 2.51939 0 2.88658e-15 -2.77556e-17 -9.76996e-15 +23 1 0.839798 1.6796 0.839798 2.33147e-15 2.22045e-16 3.34455e-15 +24 1 0 2.51939 0.839798 -1.06581e-14 -7.21645e-16 2.9976e-15 +25 1 1.6796 1.6796 0 -5.06539e-16 6.245e-17 -9.76996e-15 +26 1 2.51939 2.51939 0 -2.11636e-15 -1.72778e-15 -9.76996e-15 +27 1 2.51939 1.6796 0.839798 -1.2837e-15 9.08995e-16 2.88658e-15 +28 1 1.6796 2.51939 0.839798 3.53884e-16 -2.0331e-15 2.88658e-15 +29 1 3.35919 1.6796 0 1.34545e-14 3.46945e-17 -7.99361e-15 +30 1 4.19899 2.51939 0 -2.30926e-14 -1.85268e-15 -7.99361e-15 +31 1 4.19899 1.6796 0.839798 -2.24404e-14 -2.08167e-16 3.33067e-15 +32 1 3.35919 2.51939 0.839798 1.45925e-14 -1.36002e-15 3.33067e-15 +33 1 5.03879 1.6796 0 2.01228e-16 1.66533e-16 -7.10543e-15 +34 1 5.87859 2.51939 0 2.12677e-14 -1.74166e-15 -7.99361e-15 +35 1 5.87859 1.6796 0.839798 1.98383e-14 1.17961e-15 3.10862e-15 +36 1 5.03879 2.51939 0.839798 3.40006e-16 -2.80331e-15 2.88658e-15 +37 1 6.71838 1.6796 0 -3.10862e-15 -1.66533e-16 -8.10463e-15 +38 1 7.55818 2.51939 0 8.88178e-16 -1.33227e-15 -9.32587e-15 +39 1 7.55818 1.6796 0.839798 -8.04912e-16 1.94289e-16 3.33067e-15 +40 1 6.71838 2.51939 0.839798 -3.10862e-15 -1.66533e-15 3.56659e-15 +41 1 0 3.35919 0 -1.06581e-14 1.28786e-14 -9.54792e-15 +42 1 0.839798 4.19899 0 2.66454e-15 -2.24404e-14 -8.88178e-15 +43 1 0.839798 3.35919 0.839798 2.33147e-15 1.43774e-14 4.01068e-15 +44 1 0 4.19899 0.839798 -8.88178e-15 -2.32037e-14 2.55351e-15 +45 1 1.6796 3.35919 0 -8.53484e-16 1.47174e-14 -9.76996e-15 +46 1 2.51939 4.19899 0 -1.79717e-15 -2.32175e-14 -7.10543e-15 +47 1 2.51939 3.35919 0.839798 -5.06539e-16 1.51476e-14 3.55271e-15 +48 1 1.6796 4.19899 0.839798 -2.08167e-16 -2.40918e-14 3.33067e-15 +49 1 3.35919 3.35919 0 1.2608e-14 1.419e-14 -7.99361e-15 +50 1 4.19899 4.19899 0 -2.28706e-14 -2.25653e-14 -5.32907e-15 +51 1 4.19899 3.35919 0.839798 -2.21004e-14 1.13937e-14 2.88658e-15 +52 1 3.35919 4.19899 0.839798 1.249e-14 -2.21975e-14 2.88658e-15 +53 1 5.03879 3.35919 0 -2.22045e-16 1.14422e-14 -6.21725e-15 +54 1 5.87859 4.19899 0 2.22322e-14 -2.22461e-14 -5.32907e-15 +55 1 5.87859 3.35919 0.839798 2.14412e-14 1.27467e-14 2.88658e-15 +56 1 5.03879 4.19899 0.839798 -2.08167e-16 -2.11983e-14 3.10862e-15 +57 1 6.71838 3.35919 0 -3.60822e-15 1.32949e-14 -8.04912e-15 +58 1 7.55818 4.19899 0 8.88178e-16 -2.44249e-14 -7.10543e-15 +59 1 7.55818 3.35919 0.839798 1.66533e-16 1.40443e-14 3.10862e-15 +60 1 6.71838 4.19899 0.839798 -3.05311e-15 -2.40641e-14 2.45637e-15 +61 1 0 5.03879 0 -7.10543e-15 6.66134e-16 -7.32747e-15 +62 1 0.839798 5.87859 0 2.66454e-15 2.28706e-14 -7.10543e-15 +63 1 0.839798 5.03879 0.839798 2.55351e-15 -2.77556e-16 2.67841e-15 +64 1 0 5.87859 0.839798 -9.76996e-15 2.18159e-14 2.66454e-15 +65 1 1.6796 5.03879 0 8.32667e-17 -9.92262e-16 -6.21725e-15 +66 1 2.51939 5.87859 0 -2.08167e-15 2.16008e-14 -7.10543e-15 +67 1 2.51939 5.03879 0.839798 -1.72085e-15 3.81639e-16 3.10862e-15 +68 1 1.6796 5.87859 0.839798 -8.74301e-16 2.02824e-14 3.10862e-15 +69 1 3.35919 5.03879 0 1.08871e-14 -1.80411e-16 -6.21725e-15 +70 1 4.19899 5.87859 0 -2.27804e-14 2.17187e-14 -4.44089e-15 +71 1 4.19899 5.03879 0.839798 -1.95469e-14 -1.15186e-15 2.88658e-15 +72 1 3.35919 5.87859 0.839798 1.19973e-14 2.21143e-14 2.88658e-15 +73 1 5.03879 5.03879 0 1.17961e-16 6.8695e-16 -3.55271e-15 +74 1 5.87859 5.87859 0 2.17604e-14 2.22114e-14 -5.32907e-15 +75 1 5.87859 5.03879 0.839798 1.9415e-14 3.747e-16 2.88658e-15 +76 1 5.03879 5.87859 0.839798 -6.52256e-16 1.92069e-14 2.88658e-15 +77 1 6.71838 5.03879 0 -2.38698e-15 4.64906e-16 -6.43929e-15 +78 1 7.55818 5.87859 0 0 2.26485e-14 -7.54952e-15 +79 1 7.55818 5.03879 0.839798 1.11022e-16 1.44329e-15 2.498e-15 +80 1 6.71838 5.87859 0.839798 -2.94209e-15 2.15661e-14 2.45637e-15 +81 1 0 6.71838 0 -1.06581e-14 -3.77476e-15 -9.60343e-15 +82 1 0.839798 7.55818 0 2.44249e-15 7.91034e-16 -1.00892e-14 +83 1 0.839798 6.71838 0.839798 2.33147e-15 -2.83107e-15 3.80251e-15 +84 1 0 7.55818 0.839798 -8.88178e-15 -2.22045e-16 3.05311e-15 +85 1 1.6796 6.71838 0 -8.04912e-16 -1.72085e-15 -8.99281e-15 +86 1 2.51939 7.55818 0 -1.51268e-15 6.66134e-16 -9.54792e-15 +87 1 2.51939 6.71838 0.839798 -7.91034e-16 -2.83801e-15 3.56659e-15 +88 1 1.6796 7.55818 0.839798 2.08167e-16 2.77556e-16 3.33067e-15 +89 1 3.35919 6.71838 0 1.24623e-14 -2.22045e-15 -8.04912e-15 +90 1 4.19899 7.55818 0 -2.45221e-14 0 -7.99361e-15 +91 1 4.19899 6.71838 0.839798 -2.33563e-14 -4.89886e-15 2.45637e-15 +92 1 3.35919 7.55818 0.839798 1.30868e-14 8.88178e-16 2.88658e-15 +93 1 5.03879 6.71838 0 -4.02456e-16 -2.83107e-15 -6.43929e-15 +94 1 5.87859 7.55818 0 2.33563e-14 8.88178e-16 -7.10543e-15 +95 1 5.87859 6.71838 0.839798 2.1913e-14 -1.74166e-15 2.45637e-15 +96 1 5.03879 7.55818 0.839798 -2.08167e-16 -5.27356e-16 2.498e-15 +97 1 6.71838 6.71838 0 -2.83107e-15 -3.42781e-15 -7.10543e-15 +98 1 7.55818 7.55818 0 4.44089e-16 0 -8.88178e-15 +99 1 7.55818 6.71838 0.839798 5.55112e-17 -3.10862e-15 2.55351e-15 +100 1 6.71838 7.55818 0.839798 -2.88658e-15 5.27356e-16 2.56739e-15 +101 1 0 0 1.6796 -1.15463e-14 -1.04361e-14 -1.11022e-15 +102 1 0.839798 0.839798 1.6796 2.44249e-15 2.56739e-15 6.66134e-16 +103 1 0.839798 0 2.51939 2.66454e-15 -1.05471e-14 1.80411e-16 +104 1 0 0.839798 2.51939 -1.15463e-14 2.9976e-15 3.88578e-16 +105 1 1.6796 0 1.6796 1.73472e-16 -9.76996e-15 0 +106 1 2.51939 0.839798 1.6796 -1.71391e-15 2.66454e-15 3.88578e-16 +107 1 2.51939 0 2.51939 -1.6584e-15 -1.06581e-14 -1.4988e-15 +108 1 1.6796 0.839798 2.51939 2.63678e-16 3.10862e-15 -1.67227e-15 +109 1 3.35919 0 1.6796 1.41623e-14 -8.88178e-15 6.66134e-16 +110 1 4.19899 0.839798 1.6796 -2.18159e-14 2.44249e-15 -6.10623e-16 +111 1 4.19899 0 2.51939 -2.30371e-14 -7.99361e-15 -1.66533e-15 +112 1 3.35919 0.839798 2.51939 1.4419e-14 2.88658e-15 -1.90126e-15 +113 1 5.03879 0 1.6796 8.67362e-16 -8.88178e-15 8.88178e-16 +114 1 5.87859 0.839798 1.6796 2.02685e-14 2.44249e-15 1.02696e-15 +115 1 5.87859 0 2.51939 2.01159e-14 -8.88178e-15 -1.38778e-15 +116 1 5.03879 0.839798 2.51939 2.91434e-16 3.10862e-15 -1.45023e-15 +117 1 6.71838 0 1.6796 -2.52576e-15 -8.77076e-15 -9.02056e-17 +118 1 7.55818 0.839798 1.6796 3.747e-16 2.16493e-15 1.04083e-16 +119 1 7.55818 0 2.51939 1.33227e-15 -9.76996e-15 -1.9984e-15 +120 1 6.71838 0.839798 2.51939 -3.10862e-15 2.90046e-15 -2.10942e-15 +121 1 0 1.6796 1.6796 -1.28786e-14 8.88178e-16 6.66134e-16 +122 1 0.839798 2.51939 1.6796 2.33147e-15 -1.43635e-15 1.11022e-16 +123 1 0.839798 1.6796 2.51939 2.66454e-15 7.35523e-16 -1.30451e-15 +124 1 0 2.51939 2.51939 -1.06581e-14 -7.49401e-16 -1.44329e-15 +125 1 1.6796 1.6796 1.6796 2.22045e-16 -1.67921e-15 5.96745e-16 +126 1 2.51939 2.51939 1.6796 -8.95117e-16 -2.39392e-15 -1.3739e-15 +127 1 2.51939 1.6796 2.51939 -9.22873e-16 1.38778e-17 -1.17267e-15 +128 1 1.6796 2.51939 2.51939 1.38778e-16 -1.26982e-15 -2.16493e-15 +129 1 3.35919 1.6796 1.6796 1.44329e-14 -1.58207e-15 5.27356e-16 +130 1 4.19899 2.51939 1.6796 -2.17534e-14 -1.89432e-15 -4.85723e-16 +131 1 4.19899 1.6796 2.51939 -2.2024e-14 4.64906e-16 -2.11636e-15 +132 1 3.35919 2.51939 2.51939 1.47937e-14 -1.33227e-15 -2.23432e-15 +133 1 5.03879 1.6796 1.6796 6.38378e-16 -4.78784e-16 8.46545e-16 +134 1 5.87859 2.51939 1.6796 2.05322e-14 -1.4086e-15 2.28983e-16 +135 1 5.87859 1.6796 2.51939 2.02546e-14 -2.56739e-16 -2.07473e-15 +136 1 5.03879 2.51939 2.51939 5.82867e-16 -1.91513e-15 -2.16493e-15 +137 1 6.71838 1.6796 1.6796 -2.16493e-15 -9.4369e-16 5.55112e-17 +138 1 7.55818 2.51939 1.6796 -4.44089e-16 -1.11022e-15 -2.77556e-17 +139 1 7.55818 1.6796 2.51939 4.44089e-16 -6.93889e-18 -2.22045e-15 +140 1 6.71838 2.51939 2.51939 -3.27516e-15 -1.67921e-15 -2.38698e-15 +141 1 0 3.35919 1.6796 -1.11022e-14 1.39888e-14 -2.22045e-16 +142 1 0.839798 4.19899 1.6796 2.44249e-15 -2.1684e-14 -6.10623e-16 +143 1 0.839798 3.35919 2.51939 2.44249e-15 1.49047e-14 -1.83187e-15 +144 1 0 4.19899 2.51939 -8.88178e-15 -2.22322e-14 -1.60982e-15 +145 1 1.6796 3.35919 1.6796 2.08167e-16 1.37251e-14 5.41234e-16 +146 1 2.51939 4.19899 1.6796 -1.72778e-15 -2.28081e-14 -1.32533e-15 +147 1 2.51939 3.35919 2.51939 -9.92262e-16 1.42247e-14 -1.29757e-15 +148 1 1.6796 4.19899 2.51939 6.93889e-18 -2.16632e-14 -2.92821e-15 +149 1 3.35919 3.35919 1.6796 1.39194e-14 1.31006e-14 3.46945e-16 +150 1 4.19899 4.19899 1.6796 -2.1684e-14 -2.2142e-14 -1.26982e-15 +151 1 4.19899 3.35919 2.51939 -2.27457e-14 1.10675e-14 -2.81025e-15 +152 1 3.35919 4.19899 2.51939 1.17337e-14 -2.23849e-14 -3.15026e-15 +153 1 5.03879 3.35919 1.6796 -6.93889e-18 1.12688e-14 1.38778e-16 +154 1 5.87859 4.19899 1.6796 2.0213e-14 -2.25167e-14 2.28983e-16 +155 1 5.87859 3.35919 2.51939 2.08236e-14 1.21292e-14 -2.5327e-15 +156 1 5.03879 4.19899 2.51939 1.38778e-17 -1.97481e-14 -3.59435e-15 +157 1 6.71838 3.35919 1.6796 -2.96291e-15 1.29619e-14 -1.11716e-15 +158 1 7.55818 4.19899 1.6796 2.22045e-16 -2.33147e-14 -4.996e-16 +159 1 7.55818 3.35919 2.51939 1.33227e-15 1.33227e-14 -2.66454e-15 +160 1 6.71838 4.19899 2.51939 -3.27516e-15 -2.33147e-14 -2.84495e-15 +161 1 0 5.03879 1.6796 -7.10543e-15 4.44089e-16 0 +162 1 0.839798 5.87859 1.6796 2.44249e-15 2.08375e-14 7.21645e-16 +163 1 0.839798 5.03879 2.51939 2.88658e-15 2.63678e-16 -1.13798e-15 +164 1 0 5.87859 2.51939 -7.99361e-15 2.03171e-14 -1.44329e-15 +165 1 1.6796 5.03879 1.6796 2.56739e-16 8.60423e-16 8.04912e-16 +166 1 2.51939 5.87859 1.6796 -9.64506e-16 2.08375e-14 -7.35523e-16 +167 1 2.51939 5.03879 2.51939 -2.04003e-15 -4.57967e-16 -2.84495e-16 +168 1 1.6796 5.87859 2.51939 6.93889e-18 2.03101e-14 -7.91034e-16 +169 1 3.35919 5.03879 1.6796 1.12549e-14 2.08167e-17 1.08247e-15 +170 1 4.19899 5.87859 1.6796 -2.15591e-14 2.06987e-14 9.57567e-16 +171 1 4.19899 5.03879 2.51939 -1.96579e-14 4.30211e-16 -2.72699e-15 +172 1 3.35919 5.87859 2.51939 1.23929e-14 2.06432e-14 -2.2482e-15 +173 1 5.03879 5.03879 1.6796 2.77556e-17 -1.38778e-16 1.20737e-15 +174 1 5.87859 5.87859 1.6796 2.07542e-14 2.02408e-14 7.70217e-16 +175 1 5.87859 5.03879 2.51939 1.86587e-14 6.52256e-16 -1.7833e-15 +176 1 5.03879 5.87859 2.51939 -2.08167e-16 1.92762e-14 -1.33227e-15 +177 1 6.71838 5.03879 1.6796 -2.42167e-15 -1.31839e-16 -3.33067e-16 +178 1 7.55818 5.87859 1.6796 -2.22045e-16 2.19824e-14 2.22045e-16 +179 1 7.55818 5.03879 2.51939 -4.44089e-16 1.22125e-15 -1.9984e-15 +180 1 6.71838 5.87859 2.51939 -3.10862e-15 2.20657e-14 -2.19269e-15 +181 1 0 6.71838 1.6796 -1.02141e-14 -2.88658e-15 -6.66134e-16 +182 1 0.839798 7.55818 1.6796 1.9984e-15 6.38378e-16 2.22045e-16 +183 1 0.839798 6.71838 2.51939 2.66454e-15 -3.10862e-15 -2.08167e-15 +184 1 0 7.55818 2.51939 -9.76996e-15 4.44089e-16 -1.88738e-15 +185 1 1.6796 6.71838 1.6796 1.94289e-16 -2.31759e-15 1.249e-16 +186 1 2.51939 7.55818 1.6796 -1.249e-15 -6.17562e-16 5.55112e-17 +187 1 2.51939 6.71838 2.51939 -1.19349e-15 -3.10862e-15 -2.08167e-15 +188 1 1.6796 7.55818 2.51939 -2.22045e-16 1.33227e-15 -2.66454e-15 +189 1 3.35919 6.71838 1.6796 1.34198e-14 -2.02616e-15 -6.245e-17 +190 1 4.19899 7.55818 1.6796 -2.38282e-14 -4.71845e-16 1.45717e-16 +191 1 4.19899 6.71838 2.51939 -2.43278e-14 -4.60743e-15 -3.88578e-15 +192 1 3.35919 7.55818 2.51939 1.29896e-14 1.9984e-15 -2.22045e-15 +193 1 5.03879 6.71838 1.6796 -6.245e-17 -1.65146e-15 2.35922e-16 +194 1 5.87859 7.55818 1.6796 2.23294e-14 1.13798e-15 -6.93889e-18 +195 1 5.87859 6.71838 2.51939 2.15869e-14 -2.9976e-15 -2.63678e-15 +196 1 5.03879 7.55818 2.51939 -2.22045e-16 -2.22045e-16 -1.77636e-15 +197 1 6.71838 6.71838 1.6796 -2.62984e-15 -2.59515e-15 -1.47798e-15 +198 1 7.55818 7.55818 1.6796 4.44089e-16 2.22045e-16 -8.32667e-17 +199 1 7.55818 6.71838 2.51939 8.88178e-16 -2.27596e-15 -2.66454e-15 +200 1 6.71838 7.55818 2.51939 -2.9976e-15 7.91034e-16 -1.91513e-15 +201 1 0 0 3.35919 -1.06581e-14 -1.04361e-14 1.35447e-14 +202 1 0.839798 0.839798 3.35919 2.66454e-15 2.67841e-15 1.50435e-14 +203 1 0.839798 0 4.19899 2.66454e-15 -8.77076e-15 -2.26139e-14 +204 1 0 0.839798 4.19899 -8.88178e-15 2.88658e-15 -2.24265e-14 +205 1 1.6796 0 3.35919 1.73472e-16 -8.88178e-15 1.42109e-14 +206 1 2.51939 0.839798 3.35919 -1.83881e-15 2.77556e-15 1.55431e-14 +207 1 2.51939 0 4.19899 -1.67227e-15 -7.99361e-15 -2.32037e-14 +208 1 1.6796 0.839798 4.19899 -1.8735e-16 3.33067e-15 -2.28637e-14 +209 1 3.35919 0 3.35919 1.37182e-14 -7.99361e-15 1.44329e-14 +210 1 4.19899 0.839798 3.35919 -2.30232e-14 2.66454e-15 1.19071e-14 +211 1 4.19899 0 4.19899 -2.27665e-14 -5.32907e-15 -2.27041e-14 +212 1 3.35919 0.839798 4.19899 1.24276e-14 2.88658e-15 -2.27457e-14 +213 1 5.03879 0 3.35919 -2.08167e-17 -7.99361e-15 1.11022e-14 +214 1 5.87859 0.839798 3.35919 2.2489e-14 2.55351e-15 1.36002e-14 +215 1 5.87859 0 4.19899 2.21143e-14 -5.32907e-15 -2.24265e-14 +216 1 5.03879 0.839798 4.19899 -1.08941e-15 3.55271e-15 -2.22461e-14 +217 1 6.71838 0 3.35919 -2.47025e-15 -8.77076e-15 1.29619e-14 +218 1 7.55818 0.839798 3.35919 -1.11022e-15 2.60902e-15 1.4766e-14 +219 1 7.55818 0 4.19899 1.33227e-15 -6.43929e-15 -2.4647e-14 +220 1 6.71838 0.839798 4.19899 -2.38698e-15 2.67841e-15 -2.39531e-14 +221 1 0 1.6796 3.35919 -1.11022e-14 -2.22045e-16 1.44329e-14 +222 1 0.839798 2.51939 3.35919 2.77556e-15 -4.64906e-16 1.52378e-14 +223 1 0.839798 1.6796 4.19899 2.88658e-15 2.498e-16 -2.32592e-14 +224 1 0 2.51939 4.19899 -8.88178e-15 -1.60982e-15 -2.32592e-14 +225 1 1.6796 1.6796 3.35919 2.22045e-16 -7.91034e-16 1.5779e-14 +226 1 2.51939 2.51939 3.35919 -1.4086e-15 -1.02002e-15 1.46133e-14 +227 1 2.51939 1.6796 4.19899 -1.39472e-15 3.95517e-16 -2.30857e-14 +228 1 1.6796 2.51939 4.19899 -8.67362e-16 -1.45023e-15 -2.42237e-14 +229 1 3.35919 1.6796 3.35919 1.39888e-14 -2.77556e-17 1.57235e-14 +230 1 4.19899 2.51939 3.35919 -2.32939e-14 -1.64452e-15 1.24276e-14 +231 1 4.19899 1.6796 4.19899 -2.19755e-14 -9.08995e-16 -2.30302e-14 +232 1 3.35919 2.51939 4.19899 1.17822e-14 -2.00534e-15 -2.40433e-14 +233 1 5.03879 1.6796 3.35919 -2.498e-16 -9.22873e-16 1.29757e-14 +234 1 5.87859 2.51939 3.35919 2.13649e-14 -8.67362e-16 1.27398e-14 +235 1 5.87859 1.6796 4.19899 2.08236e-14 -7.42462e-16 -2.31828e-14 +236 1 5.03879 2.51939 4.19899 -4.30211e-16 -1.67227e-15 -2.22253e-14 +237 1 6.71838 1.6796 3.35919 -3.19883e-15 -4.996e-16 1.39264e-14 +238 1 7.55818 2.51939 3.35919 -4.44089e-16 -1.9984e-15 1.24345e-14 +239 1 7.55818 1.6796 4.19899 -4.44089e-16 -5.06539e-16 -2.39808e-14 +240 1 6.71838 2.51939 4.19899 -2.44249e-15 -1.47105e-15 -2.40641e-14 +241 1 0 3.35919 3.35919 -1.11022e-14 1.33227e-14 1.31006e-14 +242 1 0.839798 4.19899 3.35919 2.66454e-15 -2.26555e-14 1.12133e-14 +243 1 0.839798 3.35919 4.19899 2.44249e-15 1.28925e-14 -2.26208e-14 +244 1 0 4.19899 4.19899 -6.21725e-15 -2.26485e-14 -2.26485e-14 +245 1 1.6796 3.35919 3.35919 2.08167e-16 1.3281e-14 1.52794e-14 +246 1 2.51939 4.19899 3.35919 -2.17187e-15 -2.33494e-14 1.22957e-14 +247 1 2.51939 3.35919 4.19899 -1.94983e-15 1.21569e-14 -2.20726e-14 +248 1 1.6796 4.19899 4.19899 -5.20417e-16 -2.2489e-14 -2.38767e-14 +249 1 3.35919 3.35919 3.35919 1.28092e-14 1.24345e-14 1.42109e-14 +250 1 4.19899 4.19899 3.35919 -2.29677e-14 -2.35575e-14 8.33361e-15 +251 1 4.19899 3.35919 4.19899 -2.33702e-14 9.08301e-15 -2.33355e-14 +252 1 3.35919 4.19899 4.19899 9.67976e-15 -2.36547e-14 -2.46539e-14 +253 1 5.03879 3.35919 3.35919 -2.28983e-16 1.06026e-14 1.14353e-14 +254 1 5.87859 4.19899 3.35919 2.19408e-14 -2.21698e-14 8.51402e-15 +255 1 5.87859 3.35919 4.19899 2.15522e-14 1.01238e-14 -2.328e-14 +256 1 5.03879 4.19899 4.19899 -5.20417e-16 -2.11775e-14 -2.23085e-14 +257 1 6.71838 3.35919 3.35919 -3.1225e-15 1.22957e-14 1.31978e-14 +258 1 7.55818 4.19899 3.35919 -1.11022e-15 -2.4647e-14 1.05471e-14 +259 1 7.55818 3.35919 4.19899 -8.88178e-16 1.113e-14 -2.53131e-14 +260 1 6.71838 4.19899 4.19899 -3.60822e-15 -2.5091e-14 -2.32731e-14 +261 1 0 5.03879 3.35919 -7.10543e-15 -2.22045e-16 1.15463e-14 +262 1 0.839798 5.87859 3.35919 2.55351e-15 2.28359e-14 1.37113e-14 +263 1 0.839798 5.03879 4.19899 2.88658e-15 -1.05471e-15 -2.20102e-14 +264 1 0 5.87859 4.19899 -5.32907e-15 2.21212e-14 -2.25375e-14 +265 1 1.6796 5.03879 3.35919 2.56739e-16 -2.498e-16 1.26843e-14 +266 1 2.51939 5.87859 3.35919 -1.31145e-15 2.16702e-14 1.30659e-14 +267 1 2.51939 5.03879 4.19899 -2.06085e-15 8.04912e-16 -2.10873e-14 +268 1 1.6796 5.87859 4.19899 -7.63278e-17 2.17118e-14 -2.12261e-14 +269 1 3.35919 5.03879 3.35919 1.10328e-14 -2.01228e-16 1.11994e-14 +270 1 4.19899 5.87859 3.35919 -2.29886e-14 2.15314e-14 1.08039e-14 +271 1 4.19899 5.03879 4.19899 -2.02338e-14 -4.92661e-16 -2.14065e-14 +272 1 3.35919 5.87859 4.19899 1.03459e-14 2.19963e-14 -2.39878e-14 +273 1 5.03879 5.03879 3.35919 -1.94289e-16 -8.04912e-16 8.64586e-15 +274 1 5.87859 5.87859 3.35919 2.18645e-14 2.20171e-14 1.02141e-14 +275 1 5.87859 5.03879 4.19899 1.98036e-14 1.38778e-16 -2.15869e-14 +276 1 5.03879 5.87859 4.19899 -3.05311e-16 1.94428e-14 -2.04628e-14 +277 1 6.71838 5.03879 3.35919 -2.35922e-15 -3.53884e-16 1.02071e-14 +278 1 7.55818 5.87859 3.35919 -8.88178e-16 2.28706e-14 1.02141e-14 +279 1 7.55818 5.03879 4.19899 -1.33227e-15 -3.05311e-16 -2.33147e-14 +280 1 6.71838 5.87859 4.19899 -3.27516e-15 2.23987e-14 -2.53547e-14 +281 1 0 6.71838 3.35919 -9.32587e-15 -3.77476e-15 1.31006e-14 +282 1 0.839798 7.55818 3.35919 2.33147e-15 1.13798e-15 1.40166e-14 +283 1 0.839798 6.71838 4.19899 2.66454e-15 -2.44249e-15 -2.37865e-14 +284 1 0 7.55818 4.19899 -6.21725e-15 -2.22045e-16 -2.50355e-14 +285 1 1.6796 6.71838 3.35919 1.94289e-16 -2.25514e-15 1.4419e-14 +286 1 2.51939 7.55818 3.35919 -1.59595e-15 -6.10623e-16 1.37668e-14 +287 1 2.51939 6.71838 4.19899 -8.95117e-16 -2.55351e-15 -2.28983e-14 +288 1 1.6796 7.55818 4.19899 -5.13478e-16 8.88178e-16 -2.44249e-14 +289 1 3.35919 6.71838 3.35919 1.20876e-14 -2.85189e-15 1.31353e-14 +290 1 4.19899 7.55818 3.35919 -2.47094e-14 -9.4369e-16 1.06026e-14 +291 1 4.19899 6.71838 4.19899 -2.41057e-14 -3.77476e-15 -2.26208e-14 +292 1 3.35919 7.55818 4.19899 1.06998e-14 1.55431e-15 -2.53131e-14 +293 1 5.03879 6.71838 3.35919 -6.245e-17 -3.36536e-15 1.00892e-14 +294 1 5.87859 7.55818 3.35919 2.328e-14 4.44089e-16 1.02696e-14 +295 1 5.87859 6.71838 4.19899 2.31135e-14 -3.33067e-15 -2.39531e-14 +296 1 5.03879 7.55818 4.19899 -6.93889e-17 2.22045e-16 -2.28706e-14 +297 1 6.71838 6.71838 3.35919 -2.63678e-15 -2.97679e-15 1.21014e-14 +298 1 7.55818 7.55818 3.35919 -4.44089e-16 2.22045e-16 1.2268e-14 +299 1 7.55818 6.71838 4.19899 0 -2.94209e-15 -2.70894e-14 +300 1 6.71838 7.55818 4.19899 -3.10862e-15 9.57567e-16 -2.65621e-14 +301 1 0 0 5.03879 -7.99361e-15 -7.77156e-15 6.66134e-16 +302 1 0.839798 0.839798 5.03879 2.44249e-15 2.56739e-15 2.22045e-16 +303 1 0.839798 0 5.87859 2.88658e-15 -7.88258e-15 2.30926e-14 +304 1 0 0.839798 5.87859 -8.88178e-15 2.88658e-15 2.23155e-14 +305 1 1.6796 0 5.03879 -3.67761e-16 -8.88178e-15 -6.66134e-16 +306 1 2.51939 0.839798 5.03879 -1.26982e-15 2.66454e-15 8.60423e-16 +307 1 2.51939 0 5.87859 -2.08167e-15 -7.99361e-15 2.15383e-14 +308 1 1.6796 0.839798 5.87859 2.63678e-16 2.88658e-15 2.07612e-14 +309 1 3.35919 0 5.03879 1.09704e-14 -7.10543e-15 1.11022e-15 +310 1 4.19899 0.839798 5.03879 -2.02546e-14 2.66454e-15 -4.996e-16 +311 1 4.19899 0 5.87859 -2.26694e-14 -5.32907e-15 2.09832e-14 +312 1 3.35919 0.839798 5.87859 1.21708e-14 2.88658e-15 2.16979e-14 +313 1 5.03879 0 5.03879 -3.1225e-16 -5.32907e-15 2.22045e-16 +314 1 5.87859 0.839798 5.03879 1.91652e-14 2.77556e-15 1.9984e-15 +315 1 5.87859 0 5.87859 2.18436e-14 -4.44089e-15 2.27041e-14 +316 1 5.03879 0.839798 5.87859 -3.747e-16 3.10862e-15 2.10387e-14 +317 1 6.71838 0 5.03879 -3.30291e-15 -5.27356e-15 8.32667e-17 +318 1 7.55818 0.839798 5.03879 -1.11022e-16 2.41474e-15 1.66533e-15 +319 1 7.55818 0 5.87859 8.88178e-16 -7.32747e-15 2.33147e-14 +320 1 6.71838 0.839798 5.87859 -2.27596e-15 2.67841e-15 2.30926e-14 +321 1 0 1.6796 5.03879 -7.99361e-15 -6.66134e-16 2.22045e-16 +322 1 0.839798 2.51939 5.03879 2.44249e-15 -1.1588e-15 5.82867e-16 +323 1 0.839798 1.6796 5.87859 2.66454e-15 7.35523e-16 2.19269e-14 +324 1 0 2.51939 5.87859 -7.99361e-15 -1.83187e-15 2.15938e-14 +325 1 1.6796 1.6796 5.03879 2.01228e-16 -5.27356e-16 1.97065e-15 +326 1 2.51939 2.51939 5.03879 -1.00614e-15 -1.22818e-15 4.16334e-17 +327 1 2.51939 1.6796 5.87859 -9.99201e-16 -1.38778e-17 2.22808e-14 +328 1 1.6796 2.51939 5.87859 1.52656e-16 -1.38778e-15 2.04003e-14 +329 1 3.35919 1.6796 5.03879 1.17545e-14 2.63678e-16 1.02696e-15 +330 1 4.19899 2.51939 5.03879 -2.02893e-14 -2.11636e-15 -4.30211e-16 +331 1 4.19899 1.6796 5.87859 -2.20032e-14 -9.02056e-16 2.10318e-14 +332 1 3.35919 2.51939 5.87859 1.25316e-14 -1.51962e-15 2.06363e-14 +333 1 5.03879 1.6796 5.03879 8.88178e-16 -5.6205e-16 2.7478e-15 +334 1 5.87859 2.51939 5.03879 1.8846e-14 -7.84095e-16 1.20737e-15 +335 1 5.87859 1.6796 5.87859 2.0664e-14 -1.14492e-15 2.01852e-14 +336 1 5.03879 2.51939 5.87859 3.60822e-16 -1.94289e-15 1.76248e-14 +337 1 6.71838 1.6796 5.03879 -3.08781e-15 -8.74301e-16 5.96745e-16 +338 1 7.55818 2.51939 5.03879 -2.22045e-16 -1.55431e-15 2.22045e-16 +339 1 7.55818 1.6796 5.87859 1.77636e-15 -9.08995e-16 2.19824e-14 +340 1 6.71838 2.51939 5.87859 -2.60902e-15 -1.94289e-15 2.10665e-14 +341 1 0 3.35919 5.03879 -8.88178e-15 1.06581e-14 4.44089e-16 +342 1 0.839798 4.19899 5.03879 2.77556e-15 -2.00534e-14 -9.71445e-16 +343 1 0.839798 3.35919 5.87859 2.66454e-15 1.26565e-14 2.26763e-14 +344 1 0 4.19899 5.87859 -7.10543e-15 -2.27318e-14 2.12053e-14 +345 1 1.6796 3.35919 5.03879 2.15106e-16 1.11022e-14 1.249e-15 +346 1 2.51939 4.19899 5.03879 -1.61676e-15 -2.07542e-14 8.32667e-17 +347 1 2.51939 3.35919 5.87859 -1.34615e-15 1.1921e-14 2.25445e-14 +348 1 1.6796 4.19899 5.87859 -8.74301e-16 -2.1684e-14 1.93387e-14 +349 1 3.35919 3.35919 5.03879 1.08247e-14 1.05055e-14 6.245e-16 +350 1 4.19899 4.19899 5.03879 -2.08722e-14 -2.192e-14 5.55112e-16 +351 1 4.19899 3.35919 5.87859 -2.34326e-14 9.83241e-15 2.01436e-14 +352 1 3.35919 4.19899 5.87859 9.61037e-15 -2.29053e-14 2.15591e-14 +353 1 5.03879 3.35919 5.03879 6.31439e-16 6.7446e-15 5.41234e-16 +354 1 5.87859 4.19899 5.03879 1.91375e-14 -2.03101e-14 2.498e-16 +355 1 5.87859 3.35919 5.87859 2.14412e-14 1.00198e-14 2.06293e-14 +356 1 5.03879 4.19899 5.87859 -2.01228e-16 -2.06224e-14 1.59386e-14 +357 1 6.71838 3.35919 5.03879 -3.02536e-15 9.69363e-15 4.85723e-17 +358 1 7.55818 4.19899 5.03879 -8.88178e-16 -2.28706e-14 -3.33067e-16 +359 1 7.55818 3.35919 5.87859 4.44089e-16 1.11855e-14 2.30926e-14 +360 1 6.71838 4.19899 5.87859 -3.44169e-15 -2.34396e-14 2.11914e-14 +361 1 0 5.03879 5.03879 -3.9968e-15 -6.66134e-16 4.44089e-16 +362 1 0.839798 5.87859 5.03879 2.66454e-15 1.93595e-14 5.55112e-16 +363 1 0.839798 5.03879 5.87859 3.10862e-15 -4.02456e-16 2.03726e-14 +364 1 0 5.87859 5.87859 -5.32907e-15 2.18159e-14 2.27596e-14 +365 1 1.6796 5.03879 5.03879 2.77556e-17 4.16334e-17 1.3739e-15 +366 1 2.51939 5.87859 5.03879 -1.56125e-15 1.82285e-14 1.76248e-15 +367 1 2.51939 5.03879 5.87859 -2.04003e-15 -1.1241e-15 1.95052e-14 +368 1 1.6796 5.87859 5.87859 2.08167e-17 2.11636e-14 2.05252e-14 +369 1 3.35919 5.03879 5.03879 8.17402e-15 3.40006e-16 3.33067e-16 +370 1 4.19899 5.87859 5.03879 -2.08653e-14 1.81868e-14 3.26128e-16 +371 1 4.19899 5.03879 5.87859 -2.05391e-14 -2.28983e-16 1.85199e-14 +372 1 3.35919 5.87859 5.87859 1.02834e-14 2.14967e-14 2.09693e-14 +373 1 5.03879 5.03879 5.03879 2.35922e-16 2.498e-16 -1.30451e-15 +374 1 5.87859 5.87859 5.03879 1.90889e-14 1.87003e-14 -2.70617e-16 +375 1 5.87859 5.03879 5.87859 1.91305e-14 8.74301e-16 1.98105e-14 +376 1 5.03879 5.87859 5.87859 1.38778e-17 1.92832e-14 1.88183e-14 +377 1 6.71838 5.03879 5.03879 -3.45557e-15 -3.05311e-16 1.51962e-15 +378 1 7.55818 5.87859 5.03879 -4.44089e-16 2.08722e-14 1.66533e-16 +379 1 7.55818 5.03879 5.87859 -1.33227e-15 5.55112e-16 2.08722e-14 +380 1 6.71838 5.87859 5.87859 -3.33067e-15 2.20102e-14 2.08999e-14 +381 1 0 6.71838 5.03879 -7.54952e-15 -4.44089e-15 8.88178e-16 +382 1 0.839798 7.55818 5.03879 2.33147e-15 4.71845e-16 9.15934e-16 +383 1 0.839798 6.71838 5.87859 2.88658e-15 -2.27596e-15 2.23016e-14 +384 1 0 7.55818 5.87859 -6.21725e-15 -2.22045e-16 2.31482e-14 +385 1 1.6796 6.71838 5.03879 -1.38778e-17 -2.86576e-15 1.27676e-15 +386 1 2.51939 7.55818 5.03879 -1.51268e-15 -8.32667e-16 6.66134e-16 +387 1 2.51939 6.71838 5.87859 -1.32533e-15 -2.27596e-15 2.22322e-14 +388 1 1.6796 7.55818 5.87859 -2.498e-16 1.77636e-15 2.13163e-14 +389 1 3.35919 6.71838 5.03879 1.05402e-14 -3.47639e-15 2.19963e-15 +390 1 4.19899 7.55818 5.03879 -2.27665e-14 -1.44329e-15 8.32667e-16 +391 1 4.19899 6.71838 5.87859 -2.39184e-14 -2.94209e-15 2.11775e-14 +392 1 3.35919 7.55818 5.87859 1.08802e-14 1.55431e-15 2.28706e-14 +393 1 5.03879 6.71838 5.03879 -7.63278e-17 -4.04538e-15 1.38778e-17 +394 1 5.87859 7.55818 5.03879 2.10457e-14 -7.21645e-16 7.21645e-16 +395 1 5.87859 6.71838 5.87859 2.31065e-14 -3.10862e-15 2.18714e-14 +396 1 5.03879 7.55818 5.87859 1.38778e-17 -4.44089e-16 2.08722e-14 +397 1 6.71838 6.71838 5.03879 -2.76168e-15 -2.74086e-15 -3.88578e-16 +398 1 7.55818 7.55818 5.03879 0 0 -6.66134e-16 +399 1 7.55818 6.71838 5.87859 0 -2.94209e-15 2.39808e-14 +400 1 6.71838 7.55818 5.87859 -3.16414e-15 7.77156e-16 2.42029e-14 +401 1 0 0 6.71838 -1.06581e-14 -1.04361e-14 -3.77476e-15 +402 1 0.839798 0.839798 6.71838 2.66454e-15 2.67841e-15 -2.72005e-15 +403 1 0.839798 0 7.55818 2.55351e-15 -9.70057e-15 1.05471e-15 +404 1 0 0.839798 7.55818 -8.88178e-15 2.66454e-15 4.44089e-16 +405 1 1.6796 0 6.71838 2.08167e-16 -7.99361e-15 -2.44249e-15 +406 1 2.51939 0.839798 6.71838 -1.8735e-15 2.77556e-15 -2.72005e-15 +407 1 2.51939 0 7.55818 -1.56819e-15 -8.88178e-15 0 +408 1 1.6796 0.839798 7.55818 -1.11022e-16 2.66454e-15 1.55431e-15 +409 1 3.35919 0 6.71838 1.26288e-14 -7.10543e-15 -2.88658e-15 +410 1 4.19899 0.839798 6.71838 -2.40641e-14 2.66454e-15 -4.69069e-15 +411 1 4.19899 0 7.55818 -2.43069e-14 -7.99361e-15 -4.44089e-16 +412 1 3.35919 0.839798 7.55818 1.38223e-14 2.66454e-15 1.33227e-15 +413 1 5.03879 0 6.71838 2.22045e-16 -6.21725e-15 -3.10862e-15 +414 1 5.87859 0.839798 6.71838 2.22183e-14 2.55351e-15 -1.4988e-15 +415 1 5.87859 0 7.55818 2.35922e-14 -6.21725e-15 -8.88178e-16 +416 1 5.03879 0.839798 7.55818 -4.71845e-16 2.55351e-15 -2.77556e-17 +417 1 6.71838 0 6.71838 -3.38618e-15 -6.99441e-15 -3.94129e-15 +418 1 7.55818 0.839798 6.71838 -1.16573e-15 2.60902e-15 -3.10862e-15 +419 1 7.55818 0 7.55818 -4.44089e-16 -8.65974e-15 -8.88178e-16 +420 1 6.71838 0.839798 7.55818 -2.27596e-15 2.45637e-15 0 +421 1 0 1.6796 6.71838 -1.02141e-14 -4.44089e-16 -3.33067e-15 +422 1 0.839798 2.51939 6.71838 2.77556e-15 -4.996e-16 -3.05311e-15 +423 1 0.839798 1.6796 7.55818 2.66454e-15 1.11022e-16 -1.66533e-16 +424 1 0 2.51939 7.55818 -7.99361e-15 -1.76248e-15 -2.22045e-16 +425 1 1.6796 1.6796 6.71838 2.08167e-16 -7.63278e-16 -2.31759e-15 +426 1 2.51939 2.51939 6.71838 -1.38778e-15 -9.99201e-16 -2.73392e-15 +427 1 2.51939 1.6796 7.55818 -1.47105e-15 5.55112e-17 7.14706e-16 +428 1 1.6796 2.51939 7.55818 -3.33067e-16 -2.06779e-15 -1.45717e-16 +429 1 3.35919 1.6796 6.71838 1.30312e-14 -6.93889e-18 -2.52576e-15 +430 1 4.19899 2.51939 6.71838 -2.37796e-14 -2.35922e-15 -4.35069e-15 +431 1 4.19899 1.6796 7.55818 -2.36061e-14 4.64906e-16 -6.45317e-16 +432 1 3.35919 2.51939 7.55818 1.29549e-14 -8.60423e-16 -1.20043e-15 +433 1 5.03879 1.6796 6.71838 0 -5.68989e-16 -2.42861e-15 +434 1 5.87859 2.51939 6.71838 2.20657e-14 -1.10328e-15 -2.7478e-15 +435 1 5.87859 1.6796 7.55818 2.22045e-14 -6.245e-16 5.20417e-16 +436 1 5.03879 2.51939 7.55818 1.38778e-16 -1.83187e-15 -8.46545e-16 +437 1 6.71838 1.6796 6.71838 -2.32453e-15 -5.06539e-16 -2.59515e-15 +438 1 7.55818 2.51939 6.71838 -2.22045e-16 -1.9984e-15 -3.4972e-15 +439 1 7.55818 1.6796 7.55818 6.66134e-16 5.55112e-17 -1.33227e-15 +440 1 6.71838 2.51939 7.55818 -2.83107e-15 -2.06779e-15 -6.66134e-16 +441 1 0 3.35919 6.71838 -1.11022e-14 1.31006e-14 -2.88658e-15 +442 1 0.839798 4.19899 6.71838 2.66454e-15 -2.28359e-14 -4.46865e-15 +443 1 0.839798 3.35919 7.55818 2.55351e-15 1.38362e-14 5.55112e-17 +444 1 0 4.19899 7.55818 -7.99361e-15 -2.44457e-14 -8.88178e-16 +445 1 1.6796 3.35919 6.71838 2.22045e-16 1.20598e-14 -2.05391e-15 +446 1 2.51939 4.19899 6.71838 -1.09635e-15 -2.38767e-14 -4.46171e-15 +447 1 2.51939 3.35919 7.55818 -1.92901e-15 1.40235e-14 -9.02056e-17 +448 1 1.6796 4.19899 7.55818 4.16334e-17 -2.43833e-14 -1.54737e-15 +449 1 3.35919 3.35919 6.71838 1.28716e-14 1.13104e-14 -2.16493e-15 +450 1 4.19899 4.19899 6.71838 -2.44943e-14 -2.37588e-14 -4.78784e-15 +451 1 4.19899 3.35919 7.55818 -2.42584e-14 1.09426e-14 6.38378e-16 +452 1 3.35919 4.19899 7.55818 1.13798e-14 -2.49245e-14 -1.59595e-15 +453 1 5.03879 3.35919 6.71838 -2.35922e-16 8.98587e-15 -1.98452e-15 +454 1 5.87859 4.19899 6.71838 2.29469e-14 -2.33771e-14 -3.1572e-15 +455 1 5.87859 3.35919 7.55818 2.34951e-14 1.07414e-14 1.80411e-15 +456 1 5.03879 4.19899 7.55818 4.16334e-17 -2.19547e-14 -1.42941e-15 +457 1 6.71838 3.35919 6.71838 -3.13638e-15 1.12688e-14 -2.26208e-15 +458 1 7.55818 4.19899 6.71838 2.22045e-16 -2.59792e-14 -1.38778e-15 +459 1 7.55818 3.35919 7.55818 0 1.28855e-14 -8.88178e-16 +460 1 6.71838 4.19899 7.55818 -2.66454e-15 -2.52992e-14 -1.05471e-15 +461 1 0 5.03879 6.71838 -6.21725e-15 2.22045e-16 -2.22045e-15 +462 1 0.839798 5.87859 6.71838 2.55351e-15 2.25375e-14 -2.38698e-15 +463 1 0.839798 5.03879 7.55818 2.66454e-15 1.38778e-17 6.38378e-16 +464 1 0 5.87859 7.55818 -6.21725e-15 2.3842e-14 -2.22045e-16 +465 1 1.6796 5.03879 6.71838 4.44089e-16 -1.17961e-15 -2.20657e-15 +466 1 2.51939 5.87859 6.71838 -1.51962e-15 2.23849e-14 -2.19269e-15 +467 1 2.51939 5.03879 7.55818 -1.90126e-15 -3.26128e-16 6.38378e-16 +468 1 1.6796 5.87859 7.55818 -6.93889e-17 2.2593e-14 1.76942e-15 +469 1 3.35919 5.03879 6.71838 1.02557e-14 -1.31839e-15 -2.20657e-15 +470 1 4.19899 5.87859 6.71838 -2.37102e-14 2.16563e-14 -1.60288e-15 +471 1 4.19899 5.03879 7.55818 -2.25375e-14 1.38778e-17 -7.63278e-16 +472 1 3.35919 5.87859 7.55818 1.15047e-14 2.3162e-14 8.32667e-16 +473 1 5.03879 5.03879 6.71838 -2.28983e-16 -1.00614e-15 -3.27516e-15 +474 1 5.87859 5.87859 6.71838 2.35922e-14 2.19824e-14 -1.88738e-15 +475 1 5.87859 5.03879 7.55818 2.15383e-14 -2.63678e-16 7.70217e-16 +476 1 5.03879 5.87859 7.55818 1.38778e-17 2.13718e-14 3.26128e-16 +477 1 6.71838 5.03879 6.71838 -3.48332e-15 -9.71445e-16 -1.83187e-15 +478 1 7.55818 5.87859 6.71838 -2.22045e-16 2.39808e-14 -3.38618e-15 +479 1 7.55818 5.03879 7.55818 -1.33227e-15 -1.17961e-16 -6.66134e-16 +480 1 6.71838 5.87859 7.55818 -2.83107e-15 2.47372e-14 -3.88578e-16 +481 1 0 6.71838 6.71838 -9.32587e-15 -3.9968e-15 -2.88658e-15 +482 1 0.839798 7.55818 6.71838 2.44249e-15 0 -2.94209e-15 +483 1 0.839798 6.71838 7.55818 2.55351e-15 -3.15026e-15 -3.33067e-16 +484 1 0 7.55818 7.55818 -8.88178e-15 0 -2.22045e-16 +485 1 1.6796 6.71838 6.71838 2.15106e-16 -3.04617e-15 -3.05311e-15 +486 1 2.51939 7.55818 6.71838 -1.54043e-15 -5.55112e-16 -2.72005e-15 +487 1 2.51939 6.71838 7.55818 -2.08167e-15 -2.55351e-15 -2.77556e-17 +488 1 1.6796 7.55818 7.55818 2.77556e-17 -6.66134e-16 -1.11022e-15 +489 1 3.35919 6.71838 6.71838 1.22749e-14 -3.60129e-15 -2.27596e-15 +490 1 4.19899 7.55818 6.71838 -2.57433e-14 -6.66134e-16 -3.27516e-15 +491 1 4.19899 6.71838 7.55818 -2.58682e-14 -3.55271e-15 4.44089e-16 +492 1 3.35919 7.55818 7.55818 1.25316e-14 0 -4.44089e-16 +493 1 5.03879 6.71838 6.71838 0 -4.14252e-15 -3.19189e-15 +494 1 5.87859 7.55818 6.71838 2.47719e-14 -4.996e-16 -2.66454e-15 +495 1 5.87859 6.71838 7.55818 2.47163e-14 -2.66454e-15 -5.55112e-17 +496 1 5.03879 7.55818 7.55818 5.55112e-17 -2.22045e-16 6.66134e-16 +497 1 6.71838 6.71838 6.71838 -2.58127e-15 -3.18495e-15 -3.03924e-15 +498 1 7.55818 7.55818 6.71838 -2.22045e-16 0 -3.05311e-15 +499 1 7.55818 6.71838 7.55818 0 -2.69229e-15 -1.33227e-15 +500 1 6.71838 7.55818 7.55818 -2.66454e-15 9.02056e-16 -2.22045e-16 +ITEM: TIMESTEP +100 +ITEM: NUMBER OF ATOMS +500 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +ITEM: ATOMS id type x y z f_2[1] f_2[2] f_2[3] +1 1 0.123071 8.38872 8.3161 -13.5034 12.7208 4.27264 +2 1 0.832093 0.789482 0.0260634 11.6405 -9.02308 5.27054 +3 1 0.829348 8.32295 0.847054 0.253685 2.42198 0.190462 +4 1 0.167866 0.883683 1.1203 3.78838 -17.5987 -23.5446 +5 1 1.84325 0.268983 0.0506746 -34.1939 -23.1747 -16.5239 +6 1 2.48966 1.02521 0.0150167 17.3336 21.4777 -8.17686 +7 1 2.69085 0.133161 0.584204 54.6376 -37.2919 -8.47938 +8 1 2.03129 0.673907 1.00581 -42.9604 37.8091 32.6152 +9 1 3.4644 0.135395 8.22513 6.66121 1.25052 1.24977 +10 1 4.03955 1.11148 8.14659 12.0412 -8.97859 6.48992 +11 1 4.19379 0.0448744 0.829139 -7.8302 -27.8417 -6.76025 +12 1 3.64841 0.913699 0.700293 -19.72 -1.80986 -1.25088 +13 1 4.95468 8.24864 0.0754237 1.84477 -0.530278 -6.08608 +14 1 5.56087 0.715896 7.89459 8.56765 -1.46102 11.0915 +15 1 5.88623 0.0411411 0.556827 1.26181 -8.5789 -11.0866 +16 1 4.92937 0.724638 0.812217 17.273 10.8714 -8.85433 +17 1 6.72739 8.38085 8.13417 -35.3805 -5.9515 28.6252 +18 1 7.72548 0.788736 0.0488514 2.00593 -21.6326 -29.6842 +19 1 7.72508 8.25409 0.930095 1.50566 4.42937 -3.62071 +20 1 6.80396 0.557293 0.840198 23.1381 -17.3706 0.134541 +21 1 0.229449 1.60533 8.39298 -14.4977 16.7962 1.07689 +22 1 0.832071 2.6454 0.0244343 3.40253 -11.2938 10.3532 +23 1 1.17502 1.54184 1.17348 -25.8959 -2.9461 -24.9151 +24 1 0.259004 2.30396 1.08005 -0.921709 -4.92947 -4.61717 +25 1 1.52612 1.69846 0.0790119 2.24081 -1.66091 4.11232 +26 1 2.32335 2.59169 0.0356063 -1.33192 -7.27448 11.4357 +27 1 2.47613 1.68798 0.866847 -6.11708 -1.09078 12.1273 +28 1 1.75964 2.46963 1.02161 -10.4242 6.62214 -9.26339 +29 1 3.18899 1.91192 0.152422 12.8306 -10.0239 -26.2805 +30 1 4.16606 2.56561 0.31819 6.19268 17.1047 -29.5908 +31 1 4.20679 1.77492 0.904599 6.39419 -20.2587 16.143 +32 1 3.29457 2.54016 0.942536 8.4707 7.62624 9.38928 +33 1 5.08962 1.70142 0.228194 -1.96985 -10.7878 -18.1781 +34 1 5.8401 2.50153 8.17919 2.2116 -4.35098 8.5453 +35 1 6.13077 1.14332 0.361455 -13.4767 12.4455 -5.6398 +36 1 5.21187 2.29543 1.04708 -21.2445 17.0192 -2.44157 +37 1 7.1904 2.12537 8.11861 -26.262 1.63538 -8.89421 +38 1 7.82272 2.3769 0.452291 6.46918 9.92036 10.2415 +39 1 7.65568 1.36632 0.837818 -8.61574 34.9087 15.0511 +40 1 6.63096 2.29607 0.833592 -3.02945 -9.31899 -38.2195 +41 1 0.0701224 3.26957 0.347776 -7.76983 -4.00147 -12.0182 +42 1 0.634247 4.2146 8.13102 5.69069 28.6823 19.9973 +43 1 0.89062 3.25892 1.01274 -8.90571 5.17288 9.1951 +44 1 8.35578 4.21333 0.756755 0.0651816 10.3427 6.16366 +45 1 1.59376 3.50824 0.337522 12.8481 -18.5931 -31.178 +46 1 2.63362 4.08805 -0.0117409 -13.6881 -31.4545 31.8377 +47 1 2.64545 3.44217 0.972182 1.32962 4.76915 -6.91838 +48 1 1.77157 4.31331 0.893182 6.24463 15.8362 30.2465 +49 1 3.30506 3.15734 -0.00281637 -4.50664 8.90697 10.0795 +50 1 4.20121 3.98351 8.24532 14.9588 -4.89636 4.16185 +51 1 4.14049 3.34001 1.03567 7.31744 -35.2634 -0.734077 +52 1 3.55633 4.09497 0.714486 -22.5487 2.59697 3.44603 +53 1 5.00488 3.2958 8.40544 4.72004 -3.7586 -0.0676635 +54 1 6.02419 4.38739 8.28472 2.63675 -3.85348 -7.36203 +55 1 5.82125 3.13701 0.812331 3.285 1.60137 -0.83853 +56 1 4.81191 4.1205 0.886429 26.0514 -19.7571 -10.6482 +57 1 6.37904 3.38462 8.29958 8.77859 5.40588 1.21659 +58 1 7.16155 4.27433 8.23885 -4.15514 -15.8519 20.8515 +59 1 7.46381 3.5222 0.62725 -6.50801 1.62892 11.1525 +60 1 6.52496 4.16064 0.796816 7.21171 -6.93074 -7.48151 +61 1 8.21062 5.02405 8.32529 2.06274 -1.43255 -7.09188 +62 1 0.856242 5.68027 8.15143 -7.33544 -9.25849 21.6195 +63 1 0.668812 5.05722 1.0253 10.4106 -11.6037 -16.0599 +64 1 0.100757 5.9519 0.987463 -8.02818 6.7945 -7.41084 +65 1 1.67634 4.74298 8.35528 -7.26839 1.52359 -11.0387 +66 1 2.38848 5.51086 0.107164 2.54651 6.03927 1.46743 +67 1 2.70757 4.93813 1.01132 -4.75577 -9.71554 1.13089 +68 1 1.3925 5.83052 0.707681 -1.14437 -6.44566 7.34655 +69 1 3.45574 4.66587 8.23291 4.73605 39.4767 5.5614 +70 1 4.43743 5.80479 0.164115 -6.64024 0.386075 1.78009 +71 1 4.2065 4.90669 0.741814 -23.5797 23.1046 -22.8102 +72 1 3.32112 5.74269 0.715517 7.3169 4.77905 3.84994 +73 1 5.16076 4.9557 8.31038 -10.6163 5.08193 1.86037 +74 1 5.94307 5.96922 0.174598 0.307423 -9.87615 -0.075099 +75 1 5.67998 4.99641 0.866467 -3.37502 0.387608 -1.06988 +76 1 5.10533 6.15466 0.974945 -0.684733 -17.9465 -18.2172 +77 1 6.66954 5.212 0.215572 3.55269 -19.7927 -9.30717 +78 1 7.63194 6.03007 0.0625005 22.452 -11.4487 -13.3981 +79 1 7.77987 5.15692 0.880268 -13.4303 3.64316 1.97115 +80 1 6.9443 6.00859 0.774386 -22.1564 -21.0173 44.3085 +81 1 0.211543 6.60981 0.114883 -6.22763 -3.96979 4.85396 +82 1 0.828363 7.71074 8.05758 6.57912 -12.175 1.18202 +83 1 0.8511 6.85772 1.00145 14.3344 -16.9148 6.86093 +84 1 0.108182 7.491 0.729711 -16.3275 13.3125 -2.16192 +85 1 1.32651 6.53754 8.31267 17.3977 32.295 0.779922 +86 1 2.45313 7.32438 0.161863 4.38219 8.94585 -15.0057 +87 1 2.22206 6.5101 0.817864 2.61276 2.64125 -0.96007 +88 1 1.71157 7.54558 0.836721 -10.8648 3.37169 8.49449 +89 1 3.33137 6.74361 0.251121 4.01956 -5.07144 -3.19134 +90 1 4.31785 7.3164 0.250439 -2.62105 14.0423 -19.3334 +91 1 4.11403 6.69271 1.01148 -3.23605 5.58393 9.21791 +92 1 3.25046 7.65301 0.863299 7.69366 -3.67127 3.31805 +93 1 5.15822 6.61638 8.39412 -15.5898 18.5262 -4.77657 +94 1 5.88176 7.47131 8.35911 1.25772 40.9097 -41.218 +95 1 5.8589 6.89406 0.716878 17.4729 -36.9167 60.1945 +96 1 5.1317 7.5805 0.887324 -15.4398 8.72154 0.622041 +97 1 6.7242 6.72984 0.126171 2.95649 13.978 -28.6002 +98 1 7.71076 7.70275 8.27387 -25.252 1.96163 47.723 +99 1 7.67756 6.66145 0.969756 13.165 19.6736 4.48693 +100 1 6.86126 7.61056 0.694229 -2.98636 3.99324 3.02821 +101 1 8.36607 8.27958 1.86716 -0.17632 -3.19355 -10.789 +102 1 0.956051 0.693329 1.82901 -1.1092 0.489919 9.03263 +103 1 0.677954 8.19357 2.69404 9.64796 -1.44576 4.92708 +104 1 8.40822 0.658358 2.57043 0.358989 35.1247 -30.1625 +105 1 1.59709 8.27384 1.6579 -3.48424 8.95256 3.83776 +106 1 2.60262 0.937274 1.91114 -6.85695 -44.4167 -8.16487 +107 1 2.77964 8.33738 2.42411 -9.97653 17.8509 12.2111 +108 1 1.80103 0.545423 2.70436 3.05773 -0.374817 -3.43865 +109 1 3.48439 0.0645578 1.59153 -12.2456 1.16104 1.511 +110 1 4.22306 0.908637 1.62246 8.21176 3.032 -1.28199 +111 1 4.10829 0.251535 2.42791 -11.6297 -7.60593 -5.50766 +112 1 3.3006 0.854758 2.76304 -19.992 -17.3193 -31.4497 +113 1 4.89013 8.37666 1.691 47.9119 57.0599 0.585594 +114 1 5.94061 0.477826 1.48406 -3.07899 1.88699 12.3275 +115 1 5.88048 0.35971 2.56281 -4.35157 -20.3865 4.17854 +116 1 4.9283 1.00358 2.55425 0.721177 -5.70224 -8.52683 +117 1 6.83323 8.16485 1.66012 -9.63203 10.6138 -6.53177 +118 1 7.60236 0.72315 1.6205 1.19764 -13.0731 15.2148 +119 1 7.46261 8.34785 2.50942 4.27014 7.86644 3.21827 +120 1 6.98477 1.01167 2.43863 -2.7077 -3.72405 10.5475 +121 1 0.201795 1.49879 1.91201 12.0746 15.4759 7.55997 +122 1 0.970651 2.5763 1.77546 9.10281 -9.21672 19.206 +123 1 1.00278 1.70354 2.64935 -4.86832 -2.32063 -12.0578 +124 1 0.220174 2.4694 2.59226 -6.06395 2.41662 -4.31274 +125 1 1.87438 1.66139 1.85364 0.0891009 8.26815 7.54904 +126 1 2.5634 2.61259 1.66324 -1.39613 -9.56029 15.7565 +127 1 2.67373 1.74855 2.48368 16.2507 26.3662 25.5413 +128 1 1.81271 2.51993 2.48462 -12.4635 -12.9481 6.24626 +129 1 3.34642 1.5174 1.55361 6.72778 19.0825 -4.097 +130 1 4.08393 2.3973 1.7811 -4.91883 6.9472 -7.45962 +131 1 3.95017 1.57032 2.47783 9.96822 8.42852 -4.63348 +132 1 3.54843 2.54548 2.73936 0.891724 -11.4891 -8.75214 +133 1 5.35058 1.38537 1.51823 -3.50731 -2.89085 5.66595 +134 1 6.023 2.29204 1.65213 -4.43652 -0.464129 22.1024 +135 1 5.94747 1.35093 2.39209 2.54676 22.9646 2.61125 +136 1 4.92685 2.18916 2.37644 10.4243 -2.12633 1.01963 +137 1 6.61187 1.36453 1.49274 0.221959 8.29598 -0.620687 +138 1 7.32473 2.28685 1.57865 28.4734 -28.9459 -8.73783 +139 1 7.72873 1.81047 2.35176 -1.00775 -9.06934 31.0045 +140 1 6.61584 2.21437 2.52479 7.01251 0.0677084 2.80218 +141 1 8.39022 3.27891 1.73012 3.49525 -5.17929 -4.65996 +142 1 0.854964 4.19407 1.69788 1.56946 -2.00702 1.06174 +143 1 0.997978 3.23715 2.67504 2.30643 5.8223 1.06858 +144 1 7.97382 3.9138 2.48815 10.0732 9.91828 -12.5132 +145 1 1.83784 3.47408 1.69517 -12.404 -3.21409 -2.66267 +146 1 2.61842 4.21682 1.90008 2.14748 0.059531 -3.785 +147 1 2.48603 3.26502 2.5249 16.8304 14.9965 0.171158 +148 1 1.68761 4.23907 2.52806 -1.01396 -4.72261 -0.795752 +149 1 3.40602 3.2813 1.85914 -16.1626 0.355927 -8.83409 +150 1 4.09906 4.10307 1.70079 5.35563 8.08157 -4.08084 +151 1 4.20252 3.30769 2.50236 16.5461 8.94662 0.427258 +152 1 3.52577 4.20363 2.52362 -12.9682 0.481811 23.6133 +153 1 5.11847 3.18122 1.75203 -10.5302 -5.4337 -0.263304 +154 1 5.84661 3.9209 1.56262 -0.517958 8.86577 8.63788 +155 1 5.86922 3.05768 2.56393 3.07392 -0.105811 -3.05554 +156 1 4.80787 4.20147 2.51562 -15.5306 -18.6016 6.98719 +157 1 6.75594 3.06184 1.51831 -23.9843 53.9056 5.35996 +158 1 7.37411 4.33015 1.50837 10.7935 -8.89263 2.38858 +159 1 7.49772 2.90887 2.46868 -6.63254 10.1343 -14.9923 +160 1 6.70853 3.86113 2.32478 1.28299 1.19192 -0.76331 +161 1 8.35107 4.97447 1.76826 -6.01727 -4.60108 12.0065 +162 1 0.812206 5.83167 1.72433 7.83055 6.4827 17.8655 +163 1 0.780537 4.91988 2.60048 6.34607 -5.57446 -13.8552 +164 1 8.22728 5.818 2.44166 16.0462 -1.57715 15.6299 +165 1 1.69572 5.11642 1.80574 -4.96566 -14.135 -5.31489 +166 1 2.43043 5.85297 1.63568 5.29915 -1.62077 5.85546 +167 1 2.57792 5.02783 2.65315 -4.52746 -19.2236 -8.91777 +168 1 1.53526 5.79854 2.60003 3.8059 -10.2938 -9.84612 +169 1 3.51815 5.02648 1.76532 -11.6984 -21.692 -35.1665 +170 1 4.20879 5.78771 1.44267 -4.45704 -9.43328 11.2812 +171 1 4.17986 5.08228 2.52246 26.037 -4.72131 -0.0794421 +172 1 3.28564 5.71935 2.4374 15.7539 34.931 2.27384 +173 1 4.77269 4.90482 1.56605 20.4715 8.53759 27.1606 +174 1 6.0822 5.98003 1.39493 -10.1112 -7.66907 2.17662 +175 1 5.55864 4.81486 2.32198 32.4427 -4.71792 -40.0608 +176 1 5.42317 5.8389 2.32907 -1.32862 11.7729 0.869635 +177 1 6.58632 5.00994 1.4228 1.50987 11.9718 7.91199 +178 1 7.40728 5.76017 1.85143 -17.7756 -1.69935 -20.7445 +179 1 7.43483 4.90248 2.50406 4.81208 -4.17509 -3.00519 +180 1 6.49032 6.25339 2.53785 -9.86939 -13.1275 -11.226 +181 1 8.38687 6.70803 1.84686 8.51598 2.67685 -7.76441 +182 1 0.82672 7.5809 1.8586 -8.65199 -8.55201 -6.88257 +183 1 0.798368 6.66179 2.58415 -9.89719 -0.151349 -9.60426 +184 1 8.09266 7.50342 2.71078 14.8523 -0.33865 -5.72558 +185 1 1.67226 6.92941 1.90638 3.68667 -6.81729 -3.8166 +186 1 2.44977 7.72472 1.67328 13.6121 -19.3583 -10.8323 +187 1 2.6005 7.00136 2.53195 -4.75836 -8.709 1.95523 +188 1 1.74762 7.69197 2.71318 -2.53247 4.05033 -0.19863 +189 1 3.12318 6.68472 1.56494 -10.4586 3.85751 -11.4518 +190 1 4.29009 7.65387 1.60791 -51.7416 -54.1223 -14.9832 +191 1 3.94907 6.70085 2.16915 18.0446 -8.10905 7.08373 +192 1 3.47208 7.58339 2.49347 14.5465 5.92984 -2.02778 +193 1 5.12563 6.77282 1.76131 -9.48863 14.4825 6.97263 +194 1 5.83539 7.62987 1.64588 8.72191 3.82062 7.16953 +195 1 5.76423 6.96836 2.55864 -5.64345 11.6948 11.2338 +196 1 4.77822 7.71547 2.51809 6.21883 -11.3323 9.13654 +197 1 6.63559 6.81418 1.65333 9.11964 14.1494 -8.37133 +198 1 7.61434 7.47455 1.72558 2.40335 0.461228 -6.0911 +199 1 7.4792 6.66861 2.39873 -2.80551 0.930229 8.6336 +200 1 6.74988 7.49855 2.51532 0.27108 -2.11137 5.23264 +201 1 8.33028 0.11458 3.36279 -16.5826 -29.3888 39.8482 +202 1 0.924222 0.663074 3.34599 -4.22349 8.71948 1.26084 +203 1 0.761543 8.18959 3.97906 2.12091 4.50677 4.24971 +204 1 8.33433 0.813163 4.20564 6.5007 1.52148 -0.192127 +205 1 1.76574 0.0375621 3.77071 17.3013 -16.3871 -16.9245 +206 1 2.61977 0.818953 3.52119 -23.2651 -2.55324 12.2346 +207 1 2.77562 0.0652161 4.44741 -11.8421 6.13727 -13.8855 +208 1 1.49199 0.761034 4.41597 -5.10709 15.0925 14.5126 +209 1 3.2179 8.34804 3.44668 5.27936 -7.50847 -1.90568 +210 1 3.9439 0.797129 3.52456 17.3728 2.18733 11.5361 +211 1 4.23279 0.116688 4.32559 -2.42219 -2.56552 -2.26636 +212 1 3.32804 0.997948 4.36883 1.65433 -5.54648 3.47818 +213 1 4.71275 0.120112 3.21294 23.362 4.56383 23.3458 +214 1 5.81093 1.04185 3.50642 -3.03834 -26.4106 -17.8435 +215 1 5.68877 0.288558 4.20831 -1.41276 -13.7346 9.5471 +216 1 5.01865 1.1392 4.32627 0.968145 -3.23051 -6.43149 +217 1 6.64793 8.39618 3.24984 2.09632 -4.36032 3.69009 +218 1 7.5883 0.965027 3.40354 -4.44096 -3.20185 -1.58139 +219 1 7.46506 8.38162 4.26807 1.21074 2.40143 -20.8016 +220 1 6.68567 0.729309 4.05423 9.00491 -0.0257829 7.04417 +221 1 0.0217051 1.65067 3.33296 -0.896942 -12.0422 -1.44038 +222 1 0.778955 2.33585 3.53158 8.17696 34.6193 -17.2054 +223 1 0.812105 1.63712 4.22741 2.15493 -21.1842 9.58449 +224 1 8.36402 2.71734 4.23224 9.90405 -0.180735 2.89262 +225 1 1.64503 1.55583 3.44456 9.91651 -2.24847 10.5707 +226 1 2.72789 2.60115 3.33289 -22.1633 -6.4618 14.3253 +227 1 2.53285 1.75288 4.15927 -11.2604 4.59027 8.59695 +228 1 1.59486 2.51559 4.29587 -0.634079 -19.903 20.3392 +229 1 3.26158 1.6458 3.43181 16.9482 17.4067 -1.31054 +230 1 4.49124 2.67296 3.29881 0.516577 8.93567 6.85853 +231 1 4.12441 1.76399 4.16025 -12.4119 -16.9863 20.8263 +232 1 3.58648 2.62356 4.12513 -11.0948 -0.0880381 2.09248 +233 1 4.62064 1.66433 3.30411 17.3359 -14.3916 -7.7698 +234 1 5.72203 2.02067 3.4449 -2.49843 31.6335 -13.0426 +235 1 6.15135 1.60495 4.33133 -9.75959 4.02084 8.19224 +236 1 5.04088 2.23941 4.27882 30.2001 -2.39587 -19.7025 +237 1 6.91779 1.8813 3.52264 3.96777 -26.054 4.41687 +238 1 7.81771 2.53776 3.353 -2.77684 -3.41763 12.6677 +239 1 7.78069 1.81171 4.34601 -52.3825 1.07947 -51.791 +240 1 6.66141 2.49312 4.62997 -6.69802 -0.0628228 -12.7191 +241 1 0.122629 3.46604 3.3479 -1.26446 -22.7991 -11.2332 +242 1 0.85888 4.22824 3.46647 2.79502 3.87933 -3.60293 +243 1 0.937247 3.40088 4.29114 -12.1658 -1.27655 -7.25993 +244 1 8.30307 4.19021 4.02192 -7.37977 10.0618 19.4199 +245 1 1.73804 3.18337 3.5685 -15.8464 9.26468 -37.1326 +246 1 2.58615 4.05913 3.19953 0.360202 14.7294 -1.16411 +247 1 2.55925 3.4674 4.05471 16.7959 -2.51521 13.6147 +248 1 1.75131 4.20697 4.04231 3.51698 -5.56503 7.27084 +249 1 3.44857 3.37138 3.44602 9.39764 18.3315 -14.5187 +250 1 4.30487 4.37452 3.51867 -0.743412 -11.0963 -4.3924 +251 1 4.41614 3.34547 4.13696 17.6233 7.57534 -14.2893 +252 1 3.32801 4.25542 4.08286 6.07649 -1.13934 3.22429 +253 1 5.63651 3.09553 3.631 -4.7187 3.44811 6.48572 +254 1 5.99275 4.08946 3.17209 -2.06613 -3.23888 -8.73239 +255 1 6.47603 3.67609 4.18744 -9.24013 0.891239 -0.0265923 +256 1 5.32989 4.17403 4.01248 -3.14576 -0.648453 6.26049 +257 1 6.72457 2.86539 3.51605 -3.69406 17.3565 -4.96963 +258 1 7.32281 3.76777 3.25105 -10.2265 -1.63605 18.2335 +259 1 7.4303 3.25631 4.3358 5.44768 7.87627 -9.74689 +260 1 6.66407 4.65396 3.76405 -6.96361 -4.18223 2.73914 +261 1 8.26711 4.8857 3.17584 6.51218 -0.295316 -2.27808 +262 1 0.649285 5.74933 3.20979 -12.9544 -9.12523 -13.313 +263 1 1.01858 5.10915 4.40565 1.04387 0.402418 -2.70019 +264 1 0.0855082 5.80312 4.16158 -11.0199 -7.09759 8.81305 +265 1 1.78399 4.97143 3.32025 -23.7199 7.54456 -3.60592 +266 1 2.55969 5.96317 3.12483 -8.84523 11.7944 16.8138 +267 1 2.653 5.05017 3.85074 -4.37713 4.79953 16.9312 +268 1 2.04667 5.9581 4.23583 -12.9689 -9.50066 -2.67062 +269 1 3.52568 5.09169 3.32195 -1.60301 -3.74832 -0.530875 +270 1 4.17719 5.92991 3.13207 5.79449 2.84869 4.98978 +271 1 4.69237 5.20087 4.04914 -22.9168 0.480558 19.5714 +272 1 3.49623 5.87284 4.08872 -22.1914 -19.7939 -11.835 +273 1 5.22134 4.9979 3.22696 -11.435 -2.89555 -13.2152 +274 1 5.65705 6.11892 3.42751 2.78011 1.11701 -3.25891 +275 1 5.76121 5.22134 4.03501 7.67556 -2.59727 25.3068 +276 1 4.95772 6.04539 4.58052 58.0203 8.0254 -45.1554 +277 1 6.4538 5.11955 2.78748 -4.74406 7.07146 5.73728 +278 1 7.21538 5.95413 3.16364 10.7768 -10.9442 6.36207 +279 1 7.51809 5.20099 3.85697 17.9797 5.14787 9.68311 +280 1 6.63903 5.76912 4.06379 2.12496 12.0521 4.75162 +281 1 8.12324 6.45888 3.3557 6.09728 0.195353 -8.64393 +282 1 0.462088 7.19726 3.46792 19.553 -0.0547515 -15.4409 +283 1 0.957118 6.33073 3.94731 10.4711 20.6934 10.8557 +284 1 8.31788 7.62476 4.18946 -15.5996 1.5203 27.0435 +285 1 1.621 6.60508 3.20723 21.3874 20.2704 9.57573 +286 1 2.43565 7.40381 3.575 -2.23423 10.7661 -7.60718 +287 1 2.75508 6.70843 4.26783 9.69215 -9.86312 8.63304 +288 1 1.4194 7.32943 4.0782 6.712 1.12768 -13.3449 +289 1 3.55435 6.77984 3.25216 -11.0849 -3.43265 4.44657 +290 1 4.09983 7.6717 3.40332 0.775894 2.91256 6.51607 +291 1 4.08342 6.6168 4.34423 8.99422 27.9061 4.38721 +292 1 3.36001 7.55781 4.25663 44.0502 4.81661 -43.4399 +293 1 4.74991 6.77738 3.51304 4.59094 -3.55683 -10.177 +294 1 5.77556 7.6737 3.71378 -0.245399 -1.3978 -0.93703 +295 1 5.90589 6.74801 4.34426 -3.316 -4.25196 -0.216303 +296 1 4.8074 7.40991 4.34207 4.23627 19.8452 -2.32284 +297 1 6.58813 6.85169 3.45364 -7.67639 -5.27403 -11.3349 +298 1 7.50241 7.47925 3.56723 2.18816 13.5038 -24.0989 +299 1 7.40344 6.62065 4.10638 -2.8935 -4.19323 5.51308 +300 1 6.75843 7.5046 4.25149 -20.47 8.43665 16.7865 +301 1 8.33167 8.36145 4.9892 0.225809 34.2346 -31.8957 +302 1 0.576342 0.867151 5.40959 24.5697 -12.6304 -33.2572 +303 1 0.763006 0.00458111 6.00676 12.4506 6.43147 -2.11226 +304 1 8.26499 0.860176 6.08382 -7.17683 -4.07129 -51.5552 +305 1 1.81244 8.0383 4.87052 -5.76863 7.26347 -9.86755 +306 1 2.53533 1.09902 5.19234 -3.16803 0.678291 -2.97003 +307 1 2.78135 0.403413 6.40689 -26.816 9.12488 -11.3363 +308 1 1.58905 0.651353 5.66283 7.03419 0.981612 1.76622 +309 1 3.32058 0.106866 5.32447 -0.932856 13.5857 14.9154 +310 1 4.27557 0.92435 5.10725 -6.99093 5.63655 -6.45098 +311 1 4.28959 0.280237 5.95961 -30.2191 -30.0316 -14.6333 +312 1 3.38904 1.26869 5.835 20.8336 -7.28254 -13.6106 +313 1 5.00946 8.32617 5.09801 -7.438 6.03549 0.926349 +314 1 5.92216 0.863628 5.14574 -0.277075 -6.34381 -3.05305 +315 1 5.73427 0.0193827 5.90902 4.17974 0.428592 2.11829 +316 1 4.94752 0.963499 5.95092 36.9682 12.4342 8.28196 +317 1 6.68007 0.0753806 5.17719 -6.21888 -0.275929 -7.94036 +318 1 7.59475 0.718477 4.99 5.56935 4.26124 12.8688 +319 1 7.48253 8.3166 5.84711 10.9136 10.2783 15.4989 +320 1 6.8326 0.897437 5.9487 8.18452 -13.9005 5.8213 +321 1 0.0760609 1.64664 4.96296 26.1716 -2.70613 34.3225 +322 1 0.685552 2.56455 5.03633 12.0035 4.84556 -15.2829 +323 1 0.606729 1.82267 5.82598 7.27963 -3.46786 12.0617 +324 1 8.3293 2.58271 5.72712 2.9601 13.0212 32.1025 +325 1 1.39999 1.70565 5.12122 8.3487 -4.09076 2.04128 +326 1 2.73507 2.85653 4.90403 -0.345779 -0.804973 -4.73226 +327 1 2.41817 2.24309 5.70209 1.42091 -4.90412 -0.964796 +328 1 1.38108 2.54746 5.86585 12.2906 4.17611 0.525771 +329 1 3.33731 1.91289 4.90293 0.0185627 0.794978 8.4213 +330 1 4.3973 2.60866 4.92615 -15.1153 4.67891 22.5372 +331 1 4.2225 2.0218 5.81106 18.0418 -47.4422 -19.4137 +332 1 3.4994 2.65878 5.66207 -24.6152 28.1329 2.91513 +333 1 5.20081 1.64695 5.25699 -1.61968 25.0354 -10.6249 +334 1 5.90254 2.56674 5.38347 4.70787 3.18361 -12.95 +335 1 6.08989 1.61464 5.89214 -10.9271 -1.55847 2.77666 +336 1 5.02754 2.69198 5.87273 -13.869 2.1523 1.52243 +337 1 6.90208 1.46146 5.07178 -10.118 15.4867 -8.4201 +338 1 7.58477 2.54489 5.07036 0.223295 2.60985 -3.71518 +339 1 7.69807 1.70404 5.74305 2.65747 -7.01835 5.70621 +340 1 6.83671 2.31874 5.77518 8.75763 5.85965 2.81961 +341 1 8.33535 3.4475 5.0472 4.04483 5.65066 -3.26522 +342 1 0.908217 4.16423 5.06292 -2.0575 1.13184 -0.501506 +343 1 0.771491 3.42595 5.87741 5.33449 1.31478 -10.6197 +344 1 0.14652 4.33584 6.04676 1.00462 -8.1578 -20.2597 +345 1 1.77294 3.51463 4.93957 -1.27898 -7.63546 3.32247 +346 1 2.71396 3.96357 4.97834 15.9141 3.79204 10.1307 +347 1 2.46159 3.38803 6.16546 -1.0491 -20.8555 -15.9327 +348 1 1.72608 4.39112 6.04032 -15.046 -11.018 -10.0045 +349 1 3.71274 3.40467 4.85974 -22.3519 13.9348 10.8973 +350 1 4.57553 4.21697 4.87404 -3.96399 7.00234 -1.98713 +351 1 4.366 3.53193 5.70269 7.89254 -3.17347 6.37497 +352 1 3.55123 4.20329 5.82208 -22.8323 -11.992 0.86056 +353 1 5.31479 3.43328 4.96004 -12.842 -18.3451 -4.95866 +354 1 5.96487 4.21664 4.98586 3.26728 12.2832 1.14917 +355 1 5.67633 3.58987 5.96581 6.91479 -13.8012 -0.0730494 +356 1 5.15168 4.48521 5.88819 -0.135174 -6.62981 7.61527 +357 1 6.76571 3.37692 5.24691 -14.8051 -2.47074 -4.50431 +358 1 7.42413 4.19524 5.01259 2.27671 4.46784 -0.576517 +359 1 7.6092 3.42318 5.84837 11.8264 -15.8262 -18.7291 +360 1 6.54398 4.29611 5.89957 10.509 -8.9195 -1.16059 +361 1 0.0247094 4.83566 4.99938 1.36656 0.603431 -2.15766 +362 1 0.966205 6.14847 4.9405 -1.84638 -2.56131 10.6129 +363 1 1.10739 5.11215 5.5368 -2.77114 7.32267 -6.17701 +364 1 0.221311 5.77966 5.62316 -16.3542 -5.99991 -34.5248 +365 1 2.09075 4.80339 4.88071 -15.5377 1.88455 -3.51044 +366 1 2.76626 5.59872 5.00497 -13.1053 -0.333159 -40.3797 +367 1 2.60002 4.95633 5.81939 -13.3057 -3.60712 -16.1699 +368 1 1.73302 6.11974 5.67311 7.80367 -13.5214 9.39307 +369 1 3.69174 5.11983 4.8182 4.27828 -13.6521 -3.16237 +370 1 4.24517 5.95869 5.19837 -53.2876 -10.1225 40.5156 +371 1 4.22774 4.94663 5.7496 8.19104 22.5118 -1.663 +372 1 3.1136 6.02947 5.80151 37.6339 -12.4217 36.265 +373 1 5.23537 5.12533 5.07481 2.14794 5.35663 -5.58383 +374 1 5.80775 6.19434 5.36474 -12.1517 -18.4331 -19.8184 +375 1 5.9697 5.18437 6.0003 -7.47906 6.99384 0.912527 +376 1 4.94854 5.8692 5.99559 17.5377 -1.26338 -12.9619 +377 1 6.59757 5.09144 5.08104 3.06742 4.08464 -2.92894 +378 1 7.54367 5.98613 4.88573 -14.2361 -23.7654 7.79426 +379 1 7.60847 5.23322 5.63185 -1.35187 -6.94343 4.2911 +380 1 6.70769 5.94816 5.81677 14.1283 2.13907 3.81564 +381 1 8.22278 6.71702 5.01662 22.4316 17.1972 -3.51396 +382 1 0.869349 7.28869 4.96667 -10.0366 3.62496 3.89926 +383 1 0.896793 6.73687 5.91431 -6.40765 3.74255 3.0528 +384 1 0.0890555 7.7054 5.6706 -5.18167 -47.9244 34.8448 +385 1 1.8751 6.88564 4.94229 0.477268 -2.00274 -5.71819 +386 1 2.7587 7.55291 4.99872 -36.0591 6.05211 43.0833 +387 1 2.53846 6.82983 5.7787 -13.9577 26.1772 12.6196 +388 1 1.63934 7.57104 5.79621 -1.51722 -4.07644 10.4552 +389 1 3.46612 6.83867 5.20388 -3.25728 -8.15264 -25.1259 +390 1 4.01792 7.77747 5.13143 8.22604 -9.98488 -11.0207 +391 1 4.0616 6.71165 5.99374 37.4635 -34.7522 2.57336 +392 1 3.49035 7.48383 6.06615 -52.3442 43.3465 -6.60384 +393 1 4.82693 6.8523 5.20763 2.69445 10.0085 20.3981 +394 1 5.83663 7.67662 4.94011 2.65651 0.782445 -0.458959 +395 1 5.60118 6.903 6.05259 0.51238 5.45548 -5.22943 +396 1 4.49984 7.67391 6.05154 31.0401 -0.647522 -9.371 +397 1 6.56806 6.92617 5.22736 4.49918 -20.7724 -24.6194 +398 1 7.45007 7.68748 5.02454 6.13987 -21.0163 7.77973 +399 1 7.49751 6.80367 5.78308 -9.98894 13.1501 -5.7166 +400 1 6.63057 7.61754 5.92417 0.0687578 21.3795 23.8905 +401 1 8.32557 8.34894 6.68981 0.104638 -13.8897 -9.6087 +402 1 0.744366 0.980723 6.48852 -5.23114 -31.7269 30.0044 +403 1 1.21108 0.262565 7.55604 -5.48851 -4.18087 -6.76609 +404 1 8.40118 0.701811 7.40569 17.4537 3.62996 11.6339 +405 1 1.79336 8.32699 6.64062 -5.93242 0.737609 -0.84307 +406 1 2.60519 1.4776 6.42908 -42.7477 -20.3947 10.8513 +407 1 2.68468 8.32969 7.50367 2.82039 -8.74718 0.911275 +408 1 2.14004 0.776947 7.26895 -3.65906 16.1309 -1.11008 +409 1 3.6569 0.0715803 6.70451 13.9675 -20.3473 29.1568 +410 1 3.94985 1.1248 6.78323 8.0083 0.919865 -1.94163 +411 1 4.44955 0.15543 7.5921 -15.5929 3.09145 7.2634 +412 1 3.18676 1.19789 7.55079 30.4701 -36.3009 -8.08868 +413 1 5.10396 0.131358 6.81912 -7.97923 37.9971 -21.1894 +414 1 5.81993 0.996314 6.79068 7.76858 -21.7284 -2.73997 +415 1 5.80025 8.18188 7.49322 12.3507 -13.1302 8.70784 +416 1 4.85408 1.28227 7.42764 -12.4579 -6.47968 -9.5274 +417 1 6.58875 0.130914 6.74241 2.12753 -2.2097 0.634037 +418 1 7.59964 0.676617 6.71682 -68.3673 2.07925 42.2066 +419 1 7.52212 0.0593286 7.5834 32.5631 3.04014 -28.8024 +420 1 6.85279 0.923554 7.57208 -4.28539 1.49265 -2.17621 +421 1 8.34941 1.72633 6.6429 -6.24486 10.7883 12.2426 +422 1 0.752277 2.47155 6.72526 -3.9412 -10.7788 3.00465 +423 1 0.813192 1.63555 7.42993 -7.74314 -11.2011 -0.638694 +424 1 8.22443 2.54813 7.66732 2.56273 -1.56785 0.82339 +425 1 1.49636 1.56107 6.38447 44.5625 33.4582 -3.13704 +426 1 2.30525 2.475 6.76961 -5.35408 6.54562 -0.949005 +427 1 2.49056 1.84724 7.59513 -61.407 9.30511 10.8314 +428 1 1.49273 2.39823 7.65033 13.5773 11.0727 -11.0854 +429 1 3.37689 2.03992 6.64219 17.5424 18.1797 1.52712 +430 1 4.36556 2.35363 6.72974 2.65202 20.8248 17.9478 +431 1 3.99822 2.02063 7.6547 18.3091 -10.0739 6.1027 +432 1 3.17328 2.55424 7.53823 -10.8617 31.8229 -4.73645 +433 1 5.21112 1.76508 6.50479 -18.4173 6.52495 3.64931 +434 1 5.87572 2.50861 6.47972 17.6588 16.4017 11.3405 +435 1 6.13161 1.75643 7.42519 -6.35346 6.11936 8.80778 +436 1 5.08243 2.27965 7.49559 3.10695 14.763 0.591819 +437 1 6.90515 1.73737 6.69685 6.36969 -4.89015 -2.67266 +438 1 7.59965 2.63279 6.71489 9.55617 -0.301288 -8.47778 +439 1 7.76189 1.52013 7.52701 3.93719 -1.66085 -6.19761 +440 1 6.70724 2.6779 7.2598 -8.99322 4.2321 11.9078 +441 1 0.125444 3.31521 6.66881 -20.5423 -11.9528 1.08126 +442 1 0.364694 4.22273 7.06 15.4688 8.78987 -5.27721 +443 1 0.60791 3.34758 7.65433 9.81501 -30.9601 -14.2913 +444 1 8.0984 3.85412 7.73406 0.295867 21.4592 0.238003 +445 1 1.38869 3.28611 6.86269 8.50148 8.2104 -0.813622 +446 1 2.52476 4.25334 6.66316 13.9982 13.4488 20.9739 +447 1 2.34408 3.26799 7.64808 -1.14502 9.26403 -10.1755 +448 1 1.45935 4.43411 7.31503 0.0272838 -0.538431 -2.52173 +449 1 3.66593 3.34626 6.65797 -1.50742 -4.19973 -15.7128 +450 1 4.32339 4.28741 6.63848 -1.71153 0.00989822 -0.270268 +451 1 4.03917 3.1404 7.61252 24.7136 -10.2891 3.12208 +452 1 3.36907 3.93473 7.50701 -10.481 -0.383957 -6.9951 +453 1 4.88527 3.3354 6.73465 -0.250758 1.18323 3.20962 +454 1 5.86197 4.30684 6.74144 -6.02175 10.4775 -12.9313 +455 1 5.83143 3.4729 7.33725 -5.24712 -23.3614 7.27214 +456 1 5.04517 4.19893 7.47372 14.0277 -13.7659 1.86079 +457 1 6.67093 3.19494 6.32389 -1.08882 16.2366 5.3564 +458 1 7.58567 3.93824 6.68879 13.8607 17.9546 17.9945 +459 1 7.41034 3.22296 8.01852 -22.7502 -28.7124 0.282368 +460 1 6.74041 3.98357 7.25541 -1.38378 3.03134 11.4432 +461 1 8.11164 5.05821 6.64701 -10.3621 4.23498 3.48281 +462 1 0.434229 5.95598 6.55583 13.6324 -1.56553 39.6492 +463 1 0.429061 5.17903 7.41995 -0.29478 -7.71855 -15.5486 +464 1 8.09598 5.94892 7.38464 -0.670206 -2.17368 6.38869 +465 1 1.41611 5.29567 6.55129 0.191903 6.07763 6.12613 +466 1 2.44376 5.87825 6.63669 -4.18767 0.226771 1.1996 +467 1 2.57445 4.71437 7.62895 -9.06207 26.6712 -23.195 +468 1 1.76163 5.67875 7.56712 4.16416 -0.382203 -1.94173 +469 1 3.23562 5.1121 6.55719 20.8924 -0.347412 22.4145 +470 1 4.05367 5.80831 6.49809 -13.6658 -13.8236 9.34588 +471 1 4.3499 4.91428 7.57309 -17.8958 19.2373 1.53594 +472 1 3.33848 5.81136 8.0112 0.629066 -2.48199 -2.55986 +473 1 5.22933 5.24678 6.83002 -9.21161 -10.3226 -4.65561 +474 1 5.87231 6.12998 6.73434 -14.492 -21.708 -7.10976 +475 1 6.102 5.06631 7.42095 8.16162 7.57706 8.09799 +476 1 5.11386 5.85851 7.69037 1.37823 -1.01778 -7.91082 +477 1 6.94866 5.10876 6.52261 -0.00645701 0.734687 4.76591 +478 1 7.67078 6.01392 6.41167 -4.02477 -14.728 2.57416 +479 1 7.35061 4.96205 7.5433 24.0095 -18.1944 -20.4412 +480 1 6.9284 5.83495 7.63045 -18.4707 37.5628 2.3937 +481 1 8.28984 6.85999 6.50497 12.0319 11.2505 5.01489 +482 1 0.775248 7.71516 6.80461 7.24585 -11.6558 8.08417 +483 1 0.533688 6.7762 7.54365 3.89137 -4.31915 -15.8578 +484 1 8.2465 7.61079 7.46416 25.9419 0.696332 -26.8887 +485 1 1.73177 6.71435 6.78434 -8.61422 -0.737705 -7.23833 +486 1 2.48272 7.50206 6.80041 12.0152 -3.31551 -7.82219 +487 1 2.37093 6.72113 7.64339 9.62293 -9.48685 2.94166 +488 1 1.77272 7.59226 7.58949 -2.97267 7.70343 0.621675 +489 1 3.29197 6.66554 6.74519 -6.55378 -4.76021 6.1499 +490 1 4.04728 7.44441 6.9325 9.38301 -4.09453 15.5296 +491 1 4.12674 6.55075 7.78018 3.09461 4.03017 -1.80654 +492 1 3.3807 7.43243 7.7243 -9.78058 -0.600287 9.7772 +493 1 4.74428 6.55735 6.78071 12.1641 10.0813 15.0085 +494 1 5.30209 7.56833 6.75011 8.90694 -20.2013 0.20059 +495 1 5.88783 6.83008 7.50111 -3.28565 3.55282 5.18781 +496 1 4.85536 7.429 7.66393 -0.8844 -0.824359 14.1315 +497 1 6.78323 6.58213 6.75112 16.4005 10.5566 0.00129152 +498 1 7.49771 7.53891 6.69245 -0.0692693 6.11315 -11.5276 +499 1 7.61589 6.80831 7.76686 -5.70997 -4.77696 -9.529 +500 1 6.80731 7.4637 7.45575 -10.489 5.43873 12.05 +ITEM: TIMESTEP +200 +ITEM: NUMBER OF ATOMS +500 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +ITEM: ATOMS id type x y z f_2[1] f_2[2] f_2[3] +1 1 8.41242 8.26599 8.38785 -10.0358 6.58437 5.2801 +2 1 0.814162 0.710931 0.0523899 -37.3452 31.5986 3.80166 +3 1 0.707188 8.3394 0.783901 7.22527 -6.84977 10.4166 +4 1 0.078844 0.75192 1.11978 38.2878 -8.01586 -1.83777 +5 1 1.52052 0.0613493 8.33894 50.642 -18.5757 54.2409 +6 1 2.63022 0.777198 -0.0136511 -14.6872 26.2087 -8.24369 +7 1 2.86573 8.3667 0.519039 4.98442 -20.5506 12.9041 +8 1 1.4757 0.711348 0.992341 22.4024 -8.05229 -33.8354 +9 1 3.79318 8.20698 8.14977 -12.6173 11.8638 7.05406 +10 1 4.0381 1.06879 8.36154 -11.3644 -3.77089 -31.1235 +11 1 3.94622 0.00241404 0.83531 3.0713 5.57971 3.39388 +12 1 3.2904 1.19609 0.697286 11.5663 -9.90219 11.4209 +13 1 4.80931 8.28217 0.152557 1.5084 -10.3853 -19.3359 +14 1 5.59181 0.724855 8.1093 -26.5323 12.4899 -7.60558 +15 1 5.68752 0.120676 0.713607 11.3113 1.42738 1.49966 +16 1 4.78554 0.81043 0.585131 26.0655 -22.1296 9.76004 +17 1 6.43613 0.237453 8.26775 30.1844 -14.2258 6.08634 +18 1 7.5043 0.643436 0.0691857 2.69659 0.617275 -0.831401 +19 1 7.7682 0.0476766 1.0238 2.88283 -8.74262 5.4154 +20 1 6.83111 0.459822 0.931748 -10.2254 10.6222 -23.4955 +21 1 0.00401405 1.51379 8.26626 1.73444 -9.97848 2.73777 +22 1 0.631563 2.29056 0.214422 2.30445 -4.73927 -16.4851 +23 1 0.869727 1.5347 0.919411 -20.3113 -10.6479 -1.82401 +24 1 -0.0840974 2.27001 1.15035 26.4165 13.702 -18.8298 +25 1 1.67911 1.38813 0.0883733 4.29152 4.16945 3.72554 +26 1 2.34463 2.397 8.3967 -0.661743 10.3894 16.138 +27 1 2.41792 1.69378 0.837891 -11.9994 8.17272 5.13712 +28 1 1.50784 2.3296 0.8821 15.8347 5.46342 -6.24169 +29 1 3.19181 1.77289 8.14083 -8.92279 -4.86777 22.8625 +30 1 4.12817 2.46218 8.33741 8.13153 -11.9637 0.536015 +31 1 4.26337 1.62555 0.809789 -13.061 44.2943 -8.13534 +32 1 3.42316 2.33556 0.802814 -4.29938 0.254861 -1.13643 +33 1 5.0669 1.62594 8.33933 -4.47953 5.08137 -8.2197 +34 1 5.91213 2.40952 0.124369 -13.9 -26.0969 3.99436 +35 1 6.23275 1.281 0.442008 -1.76602 1.09435 0.219677 +36 1 5.05785 2.29128 0.753897 1.63462 9.40663 2.64296 +37 1 6.76196 1.99075 8.08873 7.25593 -6.72787 12.2575 +38 1 7.89568 2.35083 0.217856 -14.3986 10.074 -11.1844 +39 1 7.7557 1.40697 0.992421 -28.0785 15.2332 -13.5573 +40 1 6.69672 2.20109 0.984157 0.465363 17.7913 -13.2761 +41 1 8.2159 3.42858 0.185567 12.3977 0.764361 -3.90376 +42 1 0.927092 4.2442 8.41258 -26.45 -26.3493 -4.33489 +43 1 0.729094 3.09987 0.813639 -4.58702 16.175 15.6607 +44 1 0.0788068 4.49033 1.02182 1.48174 1.40892 2.78463 +45 1 1.55842 3.1508 0.126599 -1.73889 6.5262 3.04002 +46 1 2.29185 4.09245 0.0493365 -0.242842 -5.39025 -0.756334 +47 1 2.41785 3.22623 0.89121 8.0106 -0.183268 -6.38994 +48 1 1.56843 4.03679 0.931375 1.76309 0.26565 -2.14494 +49 1 3.4359 3.23233 0.0225532 -4.36687 10.8322 6.25926 +50 1 4.25669 4.07361 0.0880133 2.8279 3.66932 -9.72921 +51 1 4.34048 3.08558 0.785495 -4.69141 6.70607 0.15029 +52 1 3.59299 3.90329 0.886528 -10.5717 12.5753 -2.99495 +53 1 5.13064 3.04982 8.22833 -0.225212 8.61676 17.0697 +54 1 5.81502 4.09178 8.38841 -21.2737 -2.05468 -24.8502 +55 1 5.97613 3.1773 0.894798 -5.61602 -19.9636 -19.3342 +56 1 5.09497 3.91821 0.747666 0.511602 -0.648627 8.1507 +57 1 6.51767 3.18724 8.3864 17.647 23.2966 -13.5196 +58 1 7.37164 4.03522 8.29689 -11.4262 -6.53116 -1.21962 +59 1 7.31211 3.24078 0.704535 -4.3132 -0.596821 4.84194 +60 1 6.56447 4.1734 0.602333 27.4745 -11.0091 36.7473 +61 1 8.15631 4.68203 0.075112 10.7012 -10.9934 -7.99724 +62 1 1.11663 5.88929 8.3609 -7.93077 -20.1145 9.26986 +63 1 0.996074 4.97243 1.21409 -6.72433 0.768332 -3.74364 +64 1 0.189403 5.66667 0.913187 -7.3538 -1.57168 -7.21317 +65 1 1.58163 4.94764 0.201022 19.1991 11.3216 -0.454803 +66 1 2.29237 5.73911 0.0748948 8.80602 19.0835 -4.47029 +67 1 2.49097 4.65203 0.981363 3.25616 8.72811 -9.97843 +68 1 1.87095 5.55306 0.995907 1.03553 19.7133 11.0025 +69 1 3.18407 5.012 0.131558 5.578 6.2636 9.58863 +70 1 4.09719 5.68255 0.132658 4.03261 5.63654 -2.85988 +71 1 4.12395 4.88832 0.852082 2.34539 -1.75572 -18.9743 +72 1 3.07234 5.70133 0.969327 -0.346407 5.49919 1.56796 +73 1 5.11274 5.00399 0.171908 -9.99815 3.39538 19.3609 +74 1 5.76656 5.80521 0.11529 9.4035 3.26414 21.2303 +75 1 6.01079 5.05469 0.873922 -27.3446 -31.3954 -10.6646 +76 1 4.89913 5.95208 0.960158 8.00863 4.38535 -8.86024 +77 1 6.75863 4.93475 8.31779 -18.6284 14.8779 13.2188 +78 1 7.8245 5.62001 8.34465 11.2383 14.3374 0.909184 +79 1 7.51856 5.31135 0.853265 4.91639 -9.6583 11.5193 +80 1 6.62461 5.81662 0.841147 8.94471 25.6435 -17.3923 +81 1 0.202013 6.46046 8.33455 0.0609498 5.25542 6.45446 +82 1 0.889578 7.53674 8.33221 1.62686 -1.40391 0.0530776 +83 1 0.953366 6.38848 0.908196 -1.46223 4.85455 -5.86941 +84 1 0.145952 7.39993 0.791819 5.48829 -5.75958 -9.51465 +85 1 1.67676 6.71324 8.36121 2.78795 2.25277 6.97945 +86 1 2.21164 7.54618 8.16806 16.5579 9.64776 9.50482 +87 1 2.40278 6.62803 0.856512 -0.674903 -8.3487 -4.56859 +88 1 1.53782 7.38975 0.90846 -3.10291 8.8481 -14.5459 +89 1 3.27325 6.398 0.0420856 1.14847 -3.14438 14.8868 +90 1 4.24204 7.28724 8.33928 2.62398 3.89094 44.6004 +91 1 4.04999 6.6211 0.862788 13.5756 -10.8829 -5.05866 +92 1 3.45704 7.41684 0.605416 -19.3758 10.5723 4.19592 +93 1 5.13383 6.59732 8.2884 -30.4967 14.0841 16.2852 +94 1 5.83566 7.60311 0.0824633 -14.5596 3.16754 7.91958 +95 1 5.71227 6.86684 0.81732 11.5827 -10.7391 -7.91805 +96 1 4.90381 7.61313 0.94797 9.27737 -4.87268 -6.49352 +97 1 6.72722 6.86314 0.253587 -5.2734 -0.113759 -0.620065 +98 1 7.41232 7.77996 0.331703 18.857 -4.07135 -25.363 +99 1 7.56998 6.39348 0.735875 7.28329 1.56003 -0.789213 +100 1 6.66601 7.84216 0.965777 -32.1881 -17.8038 12.8266 +101 1 0.166766 -0.00131261 1.94063 8.32296 1.94608 -3.28266 +102 1 0.934833 0.817938 1.81275 -21.8629 -14.287 17.2076 +103 1 1.00207 0.316008 2.82556 -21.807 -5.91521 -4.01431 +104 1 8.35945 0.74 2.72116 2.32177 4.37751 -0.902675 +105 1 1.48465 8.25372 1.60749 -1.18562 -7.12983 8.20441 +106 1 2.44318 0.774258 1.4766 5.48942 -2.99924 2.57908 +107 1 2.3069 8.18025 2.36522 1.41087 2.4731 2.95424 +108 1 1.85775 0.858752 2.6061 9.12182 6.5265 -4.79678 +109 1 3.23269 0.0488049 1.82801 0.784922 27.4455 -30.2613 +110 1 4.21175 0.99942 1.57195 -9.49462 -27.3711 22.4225 +111 1 4.21293 0.25409 2.38861 -7.75181 -9.25535 -4.23311 +112 1 3.32934 0.964581 2.65137 -6.01516 -9.0041 -1.19732 +113 1 4.9787 0.193499 1.50831 -4.98755 -8.3429 -3.28083 +114 1 6.09517 0.531101 1.76326 -28.5995 19.6806 -10.71 +115 1 5.85753 8.23852 2.51303 -1.20503 -8.99564 8.87124 +116 1 5.17785 0.685106 2.40543 -1.30449 11.3507 4.36005 +117 1 6.91213 8.37413 1.83271 8.62238 -24.2277 10.2354 +118 1 7.62368 0.758482 1.85178 16.0234 8.8439 -5.1341 +119 1 7.66132 8.34118 2.51601 5.03438 -8.87196 18.1761 +120 1 6.82917 0.875718 2.51872 -7.12717 1.70889 8.15245 +121 1 0.0949053 1.53257 1.83348 -15.8355 -28.5862 13.9628 +122 1 0.822415 2.21502 1.73119 16.0449 19.2167 -17.682 +123 1 0.864878 1.50475 2.57372 12.4143 -0.0682656 8.67505 +124 1 0.199844 2.34986 2.54349 -13.4424 7.82132 10.7389 +125 1 1.68463 1.52556 1.71378 7.71699 13.5023 1.83995 +126 1 2.69369 2.59616 1.91546 -20.6965 -6.26723 -3.29779 +127 1 2.60471 1.76603 2.62425 -5.19989 2.78858 2.334 +128 1 1.44056 2.43723 2.51936 11.6798 4.82752 9.65183 +129 1 3.43446 1.65477 1.84942 -9.01773 7.52097 -5.37653 +130 1 4.19061 2.39179 1.65045 11.7616 -7.21515 -2.54075 +131 1 4.26672 1.39737 2.67586 10.1937 6.39563 -7.12371 +132 1 3.53921 2.577 2.549 6.10272 -3.10086 8.1996 +133 1 5.17395 1.33784 1.40963 0.810412 -15.8822 3.29742 +134 1 5.74074 2.13809 1.54869 21.9361 25.9957 -3.59082 +135 1 5.9363 1.515 2.34901 -9.46258 -12.7333 10.9894 +136 1 4.95982 2.19781 2.39856 0.709797 0.431383 -4.3853 +137 1 6.78917 1.32128 1.47071 -5.63197 2.68115 20.8841 +138 1 7.62581 2.16504 1.87345 17.6788 -6.34038 -2.38007 +139 1 7.68847 1.62015 2.88771 -1.999 -29.1097 -18.0204 +140 1 6.72066 2.18015 2.22288 -25.5596 -3.13399 14.9826 +141 1 8.10556 3.24278 1.47587 8.10057 -1.81275 -31.7951 +142 1 0.698788 3.89936 1.58833 21.0059 -8.7854 2.84332 +143 1 0.726156 3.39424 2.59236 2.18368 -0.846434 0.375997 +144 1 8.21488 4.03893 2.09204 -9.31366 21.6556 21.1016 +145 1 1.61294 3.13444 1.56982 -6.75222 2.4564 11.7453 +146 1 2.47309 3.97186 1.76449 2.21347 -7.98753 7.5428 +147 1 2.67292 3.22702 2.95068 5.54423 5.59107 -13.8219 +148 1 1.72826 4.2557 2.53344 -3.42962 -20.862 21.8798 +149 1 3.48214 3.13902 1.56572 3.70104 11.9942 4.11222 +150 1 4.3885 3.8788 1.62665 2.95307 16.2819 -22.5535 +151 1 4.3065 3.38859 2.48531 -9.81397 -19.0665 24.4754 +152 1 3.47101 4.13314 2.35987 0.052847 -5.96917 4.43729 +153 1 5.11162 3.02695 1.57487 -2.09605 4.71156 2.60925 +154 1 6.05823 3.77666 1.6683 -0.0795953 27.02 22.5131 +155 1 5.89604 2.8633 2.33341 1.61726 0.0933652 1.12851 +156 1 5.29152 3.73349 2.43504 2.35223 15.5067 -10.4051 +157 1 6.82698 3.04592 1.66447 4.37333 2.796 -3.08497 +158 1 7.47158 4.33914 1.21316 -2.11938 -7.51647 -10.9268 +159 1 7.68828 3.1018 2.37066 -8.14673 6.79824 16.7729 +160 1 7.09384 4.0081 2.08909 -5.93874 -19.0069 4.73504 +161 1 8.1255 5.22391 1.77055 19.2122 -25.3413 6.96334 +162 1 0.62612 5.90176 1.99772 9.96713 -14.5554 -17.3464 +163 1 0.76801 4.79289 2.36504 -2.78355 1.48316 -1.85895 +164 1 8.18318 5.95034 2.62286 5.26633 -16.349 1.23379 +165 1 1.81648 4.94963 1.84319 1.29255 4.07737 -28.8924 +166 1 2.40619 6.07189 1.89723 9.11627 0.0929027 -31.5253 +167 1 2.58707 5.01704 2.50938 -14.4694 3.44726 -14.5204 +168 1 1.72272 5.71364 2.51972 -25.0056 3.38939 29.4203 +169 1 3.42498 4.85355 1.57173 -14.1697 1.2804 16.3608 +170 1 4.15303 5.79502 1.71807 -6.58651 -0.238746 -3.12281 +171 1 4.46167 4.86212 2.18786 -1.52672 -11.6836 -0.120829 +172 1 3.29589 5.94757 2.4039 5.86702 -13.0661 19.8541 +173 1 5.03295 4.96131 1.30642 14.6935 -5.33684 5.62219 +174 1 5.82775 5.80433 1.62537 -3.48018 5.04048 -3.36734 +175 1 5.79583 4.80394 2.11298 -5.34853 -5.63002 0.159279 +176 1 5.01708 6.04912 2.32216 17.4276 -29.4439 17.4564 +177 1 6.71539 5.10912 1.63093 10.3915 -7.52696 11.1074 +178 1 7.41693 5.91425 1.78268 -24.8131 17.7871 4.30264 +179 1 7.12646 4.86445 2.63426 13.6393 21.9613 3.08537 +180 1 6.42336 6.18201 2.43584 15.1603 10.9548 -7.96948 +181 1 8.23881 6.55347 1.60468 9.12903 0.565206 1.23333 +182 1 0.678624 7.37322 1.88745 -5.46988 3.49615 -25.4292 +183 1 0.794621 6.6529 2.67297 0.0873755 -1.33888 6.26964 +184 1 8.30959 7.39568 2.5723 10.9372 15.1486 20.2523 +185 1 1.53592 6.72715 1.69313 10.3025 -8.32698 21.6565 +186 1 2.52873 7.48993 1.45805 2.51224 9.72508 0.958573 +187 1 2.57516 6.97533 2.39376 0.331622 5.62636 7.11361 +188 1 1.48127 7.49186 2.513 25.359 1.87736 0.862705 +189 1 3.42472 6.67917 1.69715 -9.14691 10.5288 -4.39359 +190 1 4.07864 7.56162 1.54537 -20.7523 -1.21573 5.0956 +191 1 4.22077 6.65705 2.50099 -12.9989 13.269 2.80638 +192 1 3.32476 7.76609 2.51834 12.0821 -31.6775 22.1813 +193 1 5.18316 6.78911 1.6853 -16.2098 8.5059 -12.8052 +194 1 5.76367 7.66024 1.61411 8.21393 8.40414 -2.16429 +195 1 5.72928 6.97443 2.55641 -4.2085 8.68736 -3.41382 +196 1 4.81509 7.65411 2.27112 9.64741 4.31731 11.3389 +197 1 6.71673 6.6577 1.40921 -4.23135 13.1654 3.72162 +198 1 7.9523 7.57862 1.62003 -19.0505 2.7611 2.11499 +199 1 7.55182 6.74669 2.5625 -26.4699 -4.16644 -1.81267 +200 1 6.71006 7.32273 2.23599 -2.19037 10.3011 3.68982 +201 1 8.3209 8.25724 3.44082 -11.2006 13.9316 -31.0885 +202 1 1.1383 0.707726 3.88488 2.87074 16.2111 -29.5751 +203 1 0.710637 8.17953 4.00977 26.7141 2.01724 45.2521 +204 1 0.017483 0.84611 4.17688 -4.01486 -16.4278 3.15279 +205 1 1.83485 0.022043 3.36625 6.99225 9.16158 -10.2142 +206 1 2.5734 1.02544 3.4638 -2.67645 -0.861554 5.53773 +207 1 2.46831 8.35234 4.18841 -8.88118 2.57467 1.82808 +208 1 1.9704 0.882634 4.50547 -3.01692 -0.258051 -7.68015 +209 1 3.15194 0.11929 3.26603 1.99843 -0.203753 6.521 +210 1 4.16362 0.594977 3.39201 1.91533 3.30238 12.0146 +211 1 4.48096 8.3197 4.27248 -34.7907 27.9025 -6.28307 +212 1 3.49096 0.991035 4.39487 -18.0924 -11.2469 -3.89782 +213 1 5.15221 8.33246 3.40287 -4.49662 4.44033 -5.3065 +214 1 5.83668 0.780008 3.22544 8.18869 5.41063 4.37051 +215 1 5.71056 8.31473 4.3397 -0.683085 13.1798 -1.88784 +216 1 5.01734 0.796017 4.33297 -1.83196 10.7479 -11.7081 +217 1 6.55531 0.0226915 3.33292 8.64001 -7.40459 4.85944 +218 1 7.40254 0.734891 3.44283 9.92215 2.2266 -9.49047 +219 1 7.60175 8.41313 4.17692 -11.7492 9.12522 14.6015 +220 1 6.69717 0.884026 4.20434 -2.52907 -5.48675 3.38708 +221 1 0.266587 1.50956 3.42506 -7.49445 4.66836 1.70669 +222 1 0.834612 2.3929 3.4535 3.19311 14.9998 -2.79098 +223 1 0.966342 1.70753 4.27772 -2.38166 -3.63555 7.29451 +224 1 8.31528 2.54359 4.03878 16.7451 -1.36482 20.306 +225 1 1.65675 1.69619 3.39484 3.12529 -6.34044 -1.62009 +226 1 2.21998 2.62053 3.66497 -8.94713 -4.89956 5.05059 +227 1 2.70158 1.84855 4.22365 -4.21065 -7.00328 -1.279 +228 1 1.73069 2.39291 4.69998 -11.0397 -15.2385 -11.7518 +229 1 3.63597 1.81901 3.49635 -5.37102 -6.0004 0.428615 +230 1 4.5181 2.45307 3.50704 1.92291 5.38714 1.37796 +231 1 4.28022 1.61295 4.532 11.684 13.523 -0.759472 +232 1 3.49161 2.67545 4.21356 3.70186 4.50981 -2.53687 +233 1 5.05676 1.45985 3.45113 -18.7528 -7.6908 -2.02124 +234 1 5.59639 2.31007 3.23954 13.071 6.11501 -14.1907 +235 1 5.90515 1.58558 4.07201 2.34854 -1.44676 5.83562 +236 1 5.6448 2.61062 4.20904 5.92031 11.7583 11.4648 +237 1 6.60245 1.81532 3.22394 -0.344578 -17.0844 -10.2298 +238 1 7.7209 2.5366 3.23021 -13.9757 26.3091 7.5372 +239 1 7.59991 1.69339 4.17685 -3.31209 -2.6982 -2.62135 +240 1 6.7571 2.48096 3.97019 3.90879 12.298 15.8753 +241 1 8.32132 3.59836 3.32434 15.1974 -18.6025 -8.65377 +242 1 0.758776 4.28533 3.41911 8.12571 10.2206 -6.43372 +243 1 0.714283 3.43939 4.05789 10.8012 -17.4951 -4.32355 +244 1 8.37038 4.20103 4.16336 -19.0683 10.428 -9.16118 +245 1 1.7111 3.58985 3.37102 -4.50013 -9.39619 -9.22108 +246 1 2.7295 4.29586 3.34058 -27.7709 -28.5377 3.76594 +247 1 2.75779 3.49033 4.0215 3.07014 12.8072 -10.7423 +248 1 1.81597 4.04867 4.27403 8.34757 5.06165 3.43123 +249 1 3.63217 3.50284 3.43026 7.64322 -9.23013 -17.5251 +250 1 4.42979 4.3957 3.21235 -5.21891 -3.02116 0.669719 +251 1 4.46277 3.52681 4.13413 -5.3566 -4.51807 -16.5208 +252 1 3.52987 4.30614 4.06609 5.60483 14.7001 10.5939 +253 1 5.31574 3.44078 3.42467 1.48508 -5.70873 13.1076 +254 1 6.44336 4.14284 2.93215 -36.0911 1.99853 0.657603 +255 1 6.52296 3.60341 4.02819 -0.573509 -3.99567 -1.18998 +256 1 5.23388 4.48156 3.97453 6.55779 -4.33302 -0.590571 +257 1 6.75544 3.08581 2.98548 -20.753 -29.7898 -6.93237 +258 1 7.36113 3.83069 3.18965 17.3707 23.8596 11.1094 +259 1 7.68707 3.36428 4.36221 -8.90323 13.3285 -23.8114 +260 1 6.58157 4.70256 3.96292 -12.6487 -1.89838 -2.64764 +261 1 8.03895 4.72186 3.2072 7.03567 0.390199 -0.150374 +262 1 0.641986 5.57832 3.32415 -3.93783 9.97933 -29.9316 +263 1 0.748525 5.2954 4.26917 10.3198 11.1143 16.7142 +264 1 8.33552 6.07931 4.24855 1.05812 -13.5964 19.1647 +265 1 1.90145 4.96491 3.42288 -7.34814 1.12325 1.52157 +266 1 2.61408 5.80343 3.49254 4.58835 0.11833 -14.0758 +267 1 2.80014 5.15473 4.32615 -31.6367 11.9713 -55.3412 +268 1 1.9564 6.07585 4.27618 -9.91164 -20.8823 -47.0179 +269 1 3.37946 4.96765 3.07865 55.664 27.3093 14.9143 +270 1 4.23608 5.59453 2.88525 -18.9133 13.1689 8.33969 +271 1 4.44604 5.19737 4.14454 -7.57666 -13.265 -14.5347 +272 1 3.6416 5.84891 3.83409 2.65328 -4.22633 -4.19185 +273 1 5.15151 5.25659 3.1676 14.0924 -4.2121 3.02426 +274 1 5.82306 6.30397 3.36345 -4.54273 -6.47443 0.566248 +275 1 5.74908 5.5163 4.09569 25.3818 -3.33304 -26.8083 +276 1 4.83867 6.14359 3.79115 -4.65662 -0.583485 3.38738 +277 1 6.22614 5.32285 2.95137 -4.13422 -8.32687 15.6358 +278 1 7.32122 5.97196 3.33835 -0.00434101 -1.28454 -1.88403 +279 1 7.49659 5.17369 4.09183 8.55988 6.64783 3.63555 +280 1 6.75151 6.22479 4.25773 -16.211 -27.6787 -10.8075 +281 1 8.29215 6.64155 3.42114 5.59717 18.8581 -19.6047 +282 1 0.763473 7.56557 3.23404 -12.9198 -1.64007 -15.2341 +283 1 1.0031 6.68313 3.72439 -4.3972 -14.7662 15.3222 +284 1 8.23363 7.61771 4.35977 7.30279 -9.1197 2.90547 +285 1 1.95141 6.6466 3.21786 0.736159 0.439247 -2.07076 +286 1 2.6385 7.59536 3.37124 -4.27783 -4.21174 -0.733124 +287 1 3.13092 6.60025 4.41497 -19.4938 11.5887 -14.0245 +288 1 1.65818 7.53719 3.85187 -1.11019 -9.22082 13.1065 +289 1 3.27775 6.71474 3.27823 1.67015 1.07042 -3.65835 +290 1 4.1525 7.8844 3.3351 -7.70608 -2.7891 -4.06245 +291 1 3.98551 7.08252 4.24517 31.7093 2.51435 -5.83578 +292 1 3.40048 7.93533 4.31596 7.03572 3.0716 -3.37554 +293 1 4.94636 7.13355 3.35885 -28.0161 -11.5072 -5.66389 +294 1 5.84413 7.52046 3.45751 31.3517 19.8289 8.4284 +295 1 5.90459 6.85513 4.30093 -7.30307 7.57049 -1.80424 +296 1 5.01344 7.53745 4.4217 23.0153 -42.676 2.37557 +297 1 6.69892 6.88846 3.31402 6.29068 2.24472 -2.02408 +298 1 7.47533 7.68601 3.37673 -12.6934 -11.1052 -3.87233 +299 1 7.49921 6.86202 4.09322 12.1924 13.0141 4.3943 +300 1 6.67133 7.90635 4.38865 4.30856 -16.1011 -10.8357 +301 1 8.27296 0.0768914 5.12036 9.18301 -5.97843 0.553246 +302 1 0.892643 0.477473 4.83579 -15.0913 15.4009 20.7636 +303 1 0.772154 0.130661 5.99646 -1.43861 1.07866 -2.10387 +304 1 8.25515 0.935072 5.88754 -0.221723 -11.6722 -2.23691 +305 1 1.48963 8.06671 4.97048 16.9477 -1.8997 -3.71962 +306 1 2.57496 1.15847 5.28752 41.8653 -9.27812 4.61709 +307 1 2.98732 0.492219 6.35067 -4.54422 -4.60939 3.20868 +308 1 1.84275 0.524647 5.86961 -0.917224 0.841047 0.660751 +309 1 2.97903 0.200446 5.09803 7.97745 -0.922342 6.62523 +310 1 4.26317 0.578438 5.09777 -3.02519 11.3137 -4.68966 +311 1 4.18994 0.120263 6.02339 -4.93913 2.59189 23.6551 +312 1 3.50295 1.24619 5.79637 -4.00764 -7.55023 -4.67003 +313 1 5.12205 8.32679 5.40632 -5.25746 3.73248 -3.11501 +314 1 5.80677 0.859185 4.97868 15.281 -0.410171 8.11126 +315 1 6.05354 -0.0201647 5.97574 -7.51195 2.16668 5.49645 +316 1 5.29101 1.10125 5.89955 -0.302158 5.37706 -3.33259 +317 1 6.70998 0.244047 5.12411 -32.2188 -6.24411 4.81733 +318 1 7.52467 0.777062 4.96861 20.8677 24.3354 -3.82818 +319 1 7.29721 0.136872 5.99355 7.05953 -3.3845 7.97045 +320 1 6.54852 0.902142 6.09075 8.2259 10.3777 -12.9847 +321 1 8.3753 1.53724 4.98157 2.17311 8.15625 3.98817 +322 1 0.71432 2.51412 5.02068 -12.4966 -5.84806 3.10051 +323 1 0.855781 1.46858 5.93628 -12.4576 1.96544 0.341226 +324 1 8.11454 2.43493 5.75559 5.15623 -3.74122 1.07022 +325 1 1.70238 1.57115 5.35189 -38.5773 5.62525 -16.043 +326 1 2.46473 3.0428 4.8535 14.9609 2.21644 20.6584 +327 1 2.4829 2.11442 5.80082 20.2757 20.5564 -2.76238 +328 1 1.44662 2.4329 5.9576 0.543772 11.9562 -7.2005 +329 1 3.29597 2.05528 5.06702 2.85074 -1.27902 5.48838 +330 1 4.71392 2.67227 4.67311 -16.586 -2.70867 4.26173 +331 1 4.23981 1.93327 5.61065 17.5416 10.5589 -1.008 +332 1 3.69151 2.91031 5.72032 0.213325 2.13196 -1.69169 +333 1 5.26041 1.83667 5.02123 6.06702 -8.01086 0.159199 +334 1 6.29681 2.56022 5.09106 -5.44623 -0.683824 -15.8447 +335 1 5.97089 1.97948 5.90875 -1.39581 -8.65091 2.36208 +336 1 5.32016 2.78712 5.54952 10.0834 -7.57686 9.12967 +337 1 6.76335 1.53665 5.10381 -6.49311 3.28388 -1.62508 +338 1 7.39244 2.59867 4.94069 -6.65618 -18.4022 10.6664 +339 1 7.39034 1.59037 5.98163 7.99848 2.50507 -1.85372 +340 1 6.86792 2.60296 5.96513 8.836 -3.98323 2.68287 +341 1 0.137435 3.52069 4.93684 -4.66205 -5.7882 5.56144 +342 1 0.88525 4.34994 4.6075 2.988 -8.04302 19.8618 +343 1 0.671447 3.60221 5.79043 18.0943 -16.6493 20.2037 +344 1 8.34285 4.28087 5.95434 -19.6744 13.1619 0.969809 +345 1 1.33416 3.36295 4.99473 8.92189 5.92429 -2.5153 +346 1 2.50305 4.23267 5.05465 -27.5248 -20.908 0.492103 +347 1 2.36725 3.37012 5.84923 -17.1073 -9.96579 7.0021 +348 1 1.45211 4.29673 5.57493 7.54138 6.26423 2.50823 +349 1 3.47656 3.71778 4.99943 12.588 -10.9937 -32.8348 +350 1 4.53758 4.28685 4.7978 -5.49767 21.5926 5.59595 +351 1 4.66123 3.56451 5.54467 -12.8933 9.0868 3.25853 +352 1 3.16215 4.0016 5.8872 6.62501 12.8548 34.5501 +353 1 5.39268 3.59146 4.74919 -4.73905 -31.3011 -11.4087 +354 1 5.76113 4.47956 4.9574 18.7428 32.3973 -5.18443 +355 1 5.78815 3.80587 5.78982 -7.10304 0.117864 -2.90029 +356 1 5.02789 4.67913 5.68892 -14.5359 -3.59396 7.83253 +357 1 6.67716 3.56196 5.1655 1.61752 2.79183 -0.67852 +358 1 7.59448 4.24592 4.9803 -6.50366 -1.98045 6.72657 +359 1 7.59718 3.39514 5.76655 2.21878 7.1556 0.646608 +360 1 6.80163 4.43627 5.8851 -3.03056 -0.645399 -10.9559 +361 1 8.29576 5.01058 4.81068 0.626199 13.0736 14.2059 +362 1 1.05047 6.19551 5.02762 -0.156468 -7.32209 -14.0064 +363 1 0.578297 5.15849 5.72641 1.63655 2.26956 0.551951 +364 1 8.23943 6.07268 5.87533 8.87399 -0.526239 1.15285 +365 1 1.76527 5.31835 4.93011 -1.00084 -16.0238 11.4126 +366 1 2.88183 5.91468 5.07925 -22.1885 -17.105 2.25231 +367 1 2.65936 4.93415 6.03537 0.686882 11.6758 -2.90902 +368 1 2.03447 5.84592 5.92534 2.47635 -18.2138 -25.6325 +369 1 3.24392 4.86959 5.11086 62.6624 1.69747 54.073 +370 1 4.07402 5.91621 4.83335 -4.98562 8.578 9.29517 +371 1 3.92826 4.74513 6.11781 2.52773 6.36319 -4.5061 +372 1 3.44964 5.83627 5.89312 16.6713 -3.51566 20.823 +373 1 5.12814 5.53194 4.84592 -22.4422 -5.59515 37.2611 +374 1 5.90308 6.17208 5.1146 -12.9736 21.9443 6.65273 +375 1 5.95357 5.13374 5.81819 6.93561 8.02219 4.14964 +376 1 4.75268 5.76162 5.94655 1.5775 -0.40438 -5.87077 +377 1 6.51586 5.41565 4.90612 17.2134 -26.1979 -1.37429 +378 1 7.5279 5.93793 5.01527 -3.38884 15.9345 -12.1825 +379 1 7.6332 5.21687 5.72128 4.22628 -40.3472 -14.2075 +380 1 6.64022 6.14894 5.87989 13.3598 -6.13205 -0.934618 +381 1 8.34458 6.85129 5.15926 -14.2808 -7.95422 -4.25663 +382 1 0.833911 7.25078 4.85532 9.11386 4.17832 -8.89911 +383 1 1.06673 6.48225 6.01607 -14.203 -6.44505 8.15493 +384 1 -0.0379195 7.65497 5.88016 -1.75378 4.76646 1.63712 +385 1 2.12599 6.69323 4.98422 2.81787 34.3524 37.6883 +386 1 2.84758 7.50703 5.20442 -10.9987 17.1664 -16.5728 +387 1 2.77128 6.71691 5.85642 -9.44911 -10.1768 15.1935 +388 1 1.58013 7.32255 5.72901 16.1676 5.29147 -4.24753 +389 1 3.6768 6.91779 5.33962 13.4611 -20.8664 1.96557 +390 1 4.03881 7.88236 5.22897 2.57592 -0.812644 -11.9679 +391 1 4.4232 6.75921 6.19682 -8.5477 -5.71312 7.44018 +392 1 3.24799 7.72667 6.18249 0.719386 0.220585 -2.48264 +393 1 4.83295 6.89566 5.2507 4.97045 -2.42982 -4.77289 +394 1 5.87897 7.61282 5.14968 -20.2612 -0.49131 -22.7769 +395 1 5.75942 6.67532 6.09541 -7.34504 3.57141 -0.447292 +396 1 5.14318 7.54839 6.30602 2.0724 10.313 -0.219969 +397 1 6.74639 6.92855 5.00696 6.96871 -0.230218 1.29861 +398 1 7.3805 7.8124 5.23875 7.69485 -10.0795 -7.08489 +399 1 7.52596 6.88746 5.90198 -6.42674 1.56965 2.19774 +400 1 6.51888 7.44621 5.87193 29.4637 -7.18826 32.3539 +401 1 8.28476 0.000423359 6.72306 2.02553 19.5279 -19.3713 +402 1 1.01888 0.905848 6.82221 -28.6303 -12.8009 -18.3361 +403 1 1.24262 8.30657 7.44334 -32.4348 0.998186 -42.9826 +404 1 0.0211475 0.824091 7.47144 0.973424 -13.5355 3.24171 +405 1 1.94007 8.12144 6.72811 7.36532 0.254467 -18.2635 +406 1 3.02097 1.5587 6.75498 -16.6323 -17.6578 -2.8331 +407 1 2.39982 0.0370076 7.66598 -2.14889 1.34284 -3.48663 +408 1 1.9688 0.847456 7.09398 30.835 -18.1107 26.5169 +409 1 3.29942 8.17609 7.18194 3.78499 -8.25924 -8.09048 +410 1 3.92844 1.06207 6.75726 8.02723 -15.5891 -9.47025 +411 1 4.52946 0.167766 7.50023 3.36063 -0.839689 -4.02118 +412 1 3.29302 0.728616 7.56048 2.70434 15.6737 2.80228 +413 1 5.10415 0.332413 6.57695 -15.8309 -23.3459 -1.79261 +414 1 5.90656 0.845621 6.88018 -8.12621 13.928 11.6173 +415 1 5.71058 8.18101 7.57391 -10.3063 5.31817 -1.8554 +416 1 4.82988 1.18118 7.265 13.8593 7.32067 6.7543 +417 1 6.57919 8.43785 7.00021 11.8406 5.1504 -4.86933 +418 1 7.5282 0.806752 6.77786 -1.5451 6.42857 5.82496 +419 1 7.48349 8.33572 7.57521 5.34797 11.8467 16.9658 +420 1 6.70557 1.08836 7.47923 9.5713 -7.54062 13.1357 +421 1 0.0382442 1.56126 6.72749 -0.0966071 11.4911 -0.854867 +422 1 0.869187 2.34639 6.83989 -3.61656 -2.89703 1.60294 +423 1 0.999275 1.45672 7.67633 -8.0034 9.48038 5.5647 +424 1 0.139215 2.63275 7.64328 -15.7892 -20.5267 5.19008 +425 1 1.88893 1.53066 6.37684 -7.83006 6.68056 5.79142 +426 1 2.1935 2.73769 6.82665 18.0903 -33.7124 -24.8324 +427 1 2.37018 1.89864 7.50076 -8.8745 -17.5059 -13.2094 +428 1 1.48561 2.41457 7.71452 -8.23366 6.90197 4.22635 +429 1 3.39063 2.48859 6.68098 16.1595 11.6225 -22.1191 +430 1 4.55604 3.04369 6.47522 -16.239 -17.1818 -0.0461326 +431 1 3.92972 1.83682 7.47298 10.0225 0.0134714 -13.9461 +432 1 3.03012 2.73851 7.57823 -7.17652 4.30522 18.5475 +433 1 5.02119 2.07008 6.4546 -13.5258 -22.6225 -4.75661 +434 1 5.65211 2.81921 6.68199 10.7014 16.4385 -2.46135 +435 1 5.81386 1.77715 7.51287 -3.39579 0.139075 -0.667502 +436 1 4.71678 2.54344 7.41951 15.4924 -28.3106 -11.236 +437 1 6.66707 1.83619 6.71865 -2.24275 1.62817 8.66814 +438 1 7.65934 2.42567 6.78337 1.29364 23.1589 -24.9484 +439 1 7.60492 1.76056 7.50233 6.44148 -25.2098 19.19 +440 1 6.42541 2.6971 7.41321 1.20391 11.9169 -7.49803 +441 1 0.132604 3.18129 6.70867 -2.29445 4.14817 -3.79866 +442 1 0.662351 4.17412 6.80772 -12.4952 0.818831 -9.43638 +443 1 0.788837 3.4069 7.65946 13.9586 12.3209 -0.784492 +444 1 8.14087 4.12742 7.481 16.3072 -9.43806 5.16356 +445 1 1.48457 3.42655 6.6105 -23.5819 5.37731 -5.67472 +446 1 2.19532 4.19793 6.62241 18.5812 -12.748 4.0704 +447 1 2.03418 3.35836 7.57671 1.74798 18.3537 22.2752 +448 1 1.46881 4.26381 7.4306 10.5669 6.85755 16.1187 +449 1 3.40116 3.57046 6.96596 -19.5489 -14.8384 -6.51121 +450 1 4.14086 4.23036 7.04697 14.6332 24.1596 -34.0677 +451 1 4.37587 3.46381 7.58097 -0.667569 -11.1793 25.3659 +452 1 3.3081 4.23862 7.84495 3.59222 -23.7983 19.5534 +453 1 5.02719 3.92296 6.55308 10.3874 19.2736 1.42121 +454 1 5.99108 4.37569 6.77029 -42.1869 -21.9594 -11.1356 +455 1 5.60639 3.61515 7.4373 -8.14506 -14.6497 -3.14446 +456 1 5.05417 4.46396 7.7264 -7.96475 -5.84314 -22.6526 +457 1 6.56389 3.51182 6.41915 7.41692 -2.85266 9.06964 +458 1 7.47152 4.32616 6.69237 -6.16955 -7.38805 -5.63513 +459 1 7.53898 3.20716 7.62579 -2.06037 -6.09637 -1.14724 +460 1 6.59589 3.90993 7.45755 23.4751 -0.996001 13.7582 +461 1 8.21483 5.0816 6.83956 12.3265 -1.95746 -0.89439 +462 1 0.465403 5.98278 6.74845 -2.0373 -17.3355 -17.4636 +463 1 0.511394 5.19401 7.82937 -10.2185 -4.74355 -3.50015 +464 1 8.12271 6.05839 7.46163 -7.84524 3.1436 -8.24587 +465 1 1.48514 4.9291 6.5693 -9.22109 4.87392 -22.494 +466 1 2.40623 5.73649 6.97099 14.0591 -30.3418 -0.240996 +467 1 2.41461 4.96776 7.80425 -3.8539 -8.74065 -18.3704 +468 1 1.44923 5.49011 7.41 13.6015 -14.5185 13.7078 +469 1 3.24542 4.75566 7.0008 -15.7357 21.5396 -25.2781 +470 1 4.03587 5.88736 6.84618 18.4928 -13.3364 -12.8531 +471 1 4.10808 5.01612 7.64484 -5.1777 21.728 20.8534 +472 1 3.29694 5.8019 7.54893 0.566822 -11.9233 11.3035 +473 1 4.81889 5.07278 6.77721 5.06549 -4.43332 1.49875 +474 1 5.96641 5.77692 6.72214 -33.9279 46.677 -28.2473 +475 1 5.88193 5.34623 7.60234 -1.49551 -23.3855 17.2998 +476 1 4.83941 5.81133 7.62234 25.0546 -26.9624 -0.550707 +477 1 6.63577 5.08354 6.75153 63.1873 3.33413 5.12133 +478 1 7.44477 5.7383 6.53202 -8.94815 26.2377 30.0386 +479 1 7.45353 4.90407 7.60234 6.61529 10.6464 -15.3985 +480 1 7.05207 6.05238 7.85033 -15.5225 4.97074 -5.49642 +481 1 8.33549 6.95757 6.75022 0.367032 -2.97861 0.255273 +482 1 0.891414 7.50932 6.49478 -4.83629 2.79466 11.3618 +483 1 1.06555 6.40917 7.42656 -9.40876 15.4887 12.6203 +484 1 0.19507 7.80618 7.47535 7.27195 -18.2248 4.26121 +485 1 1.90915 6.5235 6.63557 -10.6214 46.709 18.7487 +486 1 2.60482 7.35009 7.06318 -2.87326 8.86923 -10.12 +487 1 2.54785 6.52686 7.66612 -14.5904 -1.60347 8.59865 +488 1 1.54201 7.28494 7.4147 7.26892 14.9372 -8.95427 +489 1 3.42163 6.7113 6.72693 -9.74068 0.0780566 2.81617 +490 1 4.07503 7.52705 6.85904 11.3718 5.59625 6.13428 +491 1 4.17032 6.5317 7.69612 -24.7224 6.99609 -12.8841 +492 1 3.30541 7.28919 7.8835 -6.45113 3.62128 -9.60987 +493 1 5.18135 6.6767 7.03146 3.30189 -12.2169 -7.11599 +494 1 6.1441 7.48882 6.87735 -8.40006 -9.95553 -2.76953 +495 1 5.99111 6.52776 7.79328 26.4283 6.66779 -19.7705 +496 1 4.88188 7.45813 7.61707 18.1033 18.9899 -14.9739 +497 1 6.70265 6.55612 6.94114 4.37785 1.73726 -4.76735 +498 1 7.52255 7.69097 6.78657 -11.7433 -15.8982 -13.9562 +499 1 7.60662 7.23551 7.85952 12.3776 -11.2962 -9.39843 +500 1 6.63368 7.62048 7.85195 7.88485 3.15928 -11.7162 +ITEM: TIMESTEP +300 +ITEM: NUMBER OF ATOMS +500 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +ITEM: ATOMS id type x y z f_2[1] f_2[2] f_2[3] +1 1 0.233349 8.13006 8.37458 -13.2268 13.2109 8.94155 +2 1 0.896766 0.85308 8.30255 3.22629 3.6978 6.45643 +3 1 0.859864 0.0707018 0.945242 -23.4126 -16.0712 -18.9613 +4 1 0.0588758 0.842768 1.07285 9.62638 -2.91549 -12.4893 +5 1 1.77938 8.21846 0.149185 -27.8434 -16.3109 -1.32989 +6 1 2.24018 0.700289 8.36085 16.269 9.92358 -3.41709 +7 1 2.6315 8.21417 0.711168 13.3859 0.245092 -3.82819 +8 1 1.39092 0.935915 0.985394 12.7346 13.01 -5.10945 +9 1 3.3176 8.39636 8.17869 -11.566 -16.9274 13.6338 +10 1 3.85219 0.815062 0.0370236 10.4004 28.9589 -3.67884 +11 1 4.161 0.0319779 0.627546 1.75904 -7.59281 -2.75644 +12 1 3.11636 0.817642 0.847547 4.80203 -27.6102 -6.44654 +13 1 5.13793 8.3571 8.28888 -5.17208 4.97346 2.0085 +14 1 5.70385 0.905818 8.12031 -17.8373 19.4407 -6.83741 +15 1 5.79877 0.0963845 0.817928 -4.38032 -1.5507 0.666839 +16 1 4.98412 1.21117 0.664665 -21.555 -8.66432 0.346644 +17 1 6.45061 0.296088 8.38812 3.42924 -28.9348 -2.0588 +18 1 7.77702 0.350545 0.295684 -0.731277 11.544 -2.82186 +19 1 7.70462 8.17101 1.16161 -8.03851 17.5755 -13.9844 +20 1 6.86494 0.586624 0.875444 5.58847 2.16197 13.2587 +21 1 0.100678 1.61145 0.0186749 -1.1873 -11.6656 4.66894 +22 1 0.998429 2.3998 8.22988 -7.28085 -4.5005 5.89326 +23 1 0.828996 1.87962 0.867267 -19.2592 -9.93125 -3.90703 +24 1 8.27374 2.4894 0.580898 8.78255 -11.7455 7.53659 +25 1 1.74048 1.62493 8.26739 -9.18296 -12.9889 2.92816 +26 1 2.39558 2.37629 0.0600193 9.87685 24.4855 1.90731 +27 1 2.45445 1.58898 0.877492 -32.2642 -6.64837 2.63885 +28 1 1.65243 2.45558 0.846906 19.966 -6.37675 -0.113589 +29 1 3.02408 1.54485 8.35689 5.59986 -7.64836 -2.85923 +30 1 3.92 2.20197 8.38732 -20.8443 12.2841 2.52306 +31 1 3.77985 1.57027 0.846646 20.9907 13.6119 -1.22324 +32 1 3.10388 2.34584 0.944358 6.32701 23.9593 -3.77688 +33 1 4.85706 1.878 8.25981 8.11354 -3.87323 -9.47245 +34 1 5.78268 2.09333 0.29673 -1.36849 16.4599 4.03726 +35 1 5.97863 1.20376 0.790291 32.0463 2.36619 -11.4383 +36 1 4.88385 2.45634 0.850397 9.78281 -16.7958 -1.62774 +37 1 6.62285 1.61835 8.29579 8.05661 -4.4773 5.02204 +38 1 7.55399 2.56197 8.18132 12.8994 -8.38166 15.4695 +39 1 7.59924 1.47112 0.768275 -0.340381 -2.67871 -5.54587 +40 1 6.74877 2.64386 0.753723 -17.0902 -18.9793 -10.4389 +41 1 8.35722 3.30339 8.29621 3.88209 -7.05803 1.13469 +42 1 0.765977 3.99405 0.477073 10.4517 2.49603 -17.2656 +43 1 0.831221 3.06707 0.900453 -8.35587 -6.78904 7.02328 +44 1 0.140436 4.39767 1.19127 -1.57081 11.5239 1.23833 +45 1 1.55351 3.27393 8.36662 -0.118073 6.26889 7.92677 +46 1 2.48303 4.16731 0.14908 -13.7582 -4.26857 1.92322 +47 1 2.37333 3.17517 1.02067 -14.4692 6.50264 -31.5071 +48 1 1.65701 4.17058 1.15287 -1.5797 -1.97941 -12.8817 +49 1 3.21438 3.21157 0.146996 -20.1594 -11.7694 11.9952 +50 1 4.28321 4.06082 0.235561 -7.01013 0.464645 -7.4456 +51 1 4.00184 2.96868 0.822048 -4.54826 25.7516 -18.5713 +52 1 3.26412 4.08833 0.821613 11.1851 4.36305 6.27367 +53 1 4.93889 3.19103 0.0459746 -2.17639 -1.1271 -7.48927 +54 1 5.93535 4.0528 8.21654 -1.56333 -1.65165 1.96928 +55 1 5.75576 3.15988 0.707778 17.6817 -13.2713 5.13403 +56 1 5.2315 4.02943 0.763223 -0.452475 -6.04463 7.12931 +57 1 6.80967 3.18308 7.98158 -23.2698 3.29018 18.9116 +58 1 7.84937 4.15894 0.139115 -10.2897 11.6744 2.993 +59 1 7.56351 3.24008 0.752033 -0.468845 18.0521 -12.3044 +60 1 6.70326 3.88955 0.624889 -0.941138 0.59008 2.25635 +61 1 0.263315 4.89557 0.260533 -21.3177 5.01328 -15.5704 +62 1 0.767954 5.80979 8.30607 7.59978 -5.84563 1.67074 +63 1 1.01162 5.03409 0.908989 7.54529 2.69929 16.3999 +64 1 8.38725 5.83431 1.00337 3.61589 -4.15339 -6.36164 +65 1 1.65923 4.84747 0.0732901 -12.2718 -7.14452 -1.11973 +66 1 2.34253 5.60198 8.30655 7.91513 22.3685 24.006 +67 1 2.47075 4.92775 0.922768 -5.69599 3.89765 2.66746 +68 1 1.65076 5.8624 1.08155 8.28384 13.1663 -26.7168 +69 1 3.21032 4.96288 0.0718385 6.90275 12.0583 4.83562 +70 1 4.31683 5.81091 8.2445 -6.07106 16.001 24.4162 +71 1 4.0022 5.10933 1.08243 -0.987394 -5.51353 -4.14418 +72 1 3.08952 5.8543 1.08001 20.7019 -13.8856 -23.646 +73 1 5.04193 4.8848 0.236201 -6.75887 8.84809 -11.6728 +74 1 6.01036 5.86922 0.147762 0.616812 -0.708561 -9.8882 +75 1 6.00591 4.76669 0.704892 -5.00399 3.30231 -11.9912 +76 1 5.15986 5.7957 0.727818 -36.1273 9.99449 -4.0864 +77 1 6.87642 4.89744 0.140008 2.16293 1.86546 -13.7103 +78 1 7.84039 5.5603 8.24691 -4.77039 2.45387 6.97935 +79 1 7.61247 4.95216 0.884224 61.5464 5.54866 -31.4574 +80 1 7.13999 5.87097 0.66837 -10.4004 0.446979 -1.0889 +81 1 0.284976 6.68434 0.215945 -19.2498 8.05662 -14.0567 +82 1 0.982876 7.472 8.30358 11.1034 -5.67626 13.795 +83 1 0.874256 6.63686 1.03265 -11.7399 -6.70777 -2.09767 +84 1 0.12523 7.53526 1.06205 -15.5002 -8.52158 -32.9301 +85 1 1.53836 6.56542 0.124336 5.81155 -2.74575 2.70263 +86 1 2.45566 7.24014 0.163939 -13.7862 7.0524 3.90305 +87 1 2.38368 6.64181 1.16489 5.19309 13.0368 -14.4547 +88 1 1.55777 7.42064 0.955187 2.95317 9.919 -9.12596 +89 1 3.26105 6.57879 0.277391 6.19764 -3.88127 -4.29904 +90 1 4.21681 7.50418 8.36589 0.418779 7.33048 -0.673966 +91 1 4.2136 6.71573 0.805769 6.02261 -2.81289 0.798739 +92 1 3.49573 7.57967 0.77094 -13.8185 -15.1907 -22.6007 +93 1 4.97943 6.65519 6.77102e-05 6.49698 2.41559 -0.5205 +94 1 5.78763 7.50739 0.0292034 7.17211 6.93093 1.18788 +95 1 5.70061 6.80412 0.815144 6.83872 -8.02569 -5.22668 +96 1 4.96155 7.64188 0.754906 -1.40971 0.48378 3.60676 +97 1 6.62543 6.75834 0.212141 20.3815 -6.72799 19.0936 +98 1 7.5054 7.54064 0.228699 5.02405 -0.59125 8.31674 +99 1 7.62741 6.7648 0.966544 10.8528 -1.51524 -6.86782 +100 1 6.51764 7.61106 0.794066 -3.58188 15.2202 -2.22905 +101 1 0.0861403 8.39942 1.77523 16.561 5.47177 12.0456 +102 1 0.798241 0.867486 1.90283 5.83429 -6.22483 -1.18959 +103 1 1.01882 8.16093 2.58804 1.69129 37.21 2.68102 +104 1 8.26047 0.933232 2.39213 16.6191 -6.94084 19.3019 +105 1 1.5043 8.31602 1.70005 24.5225 8.22354 6.48742 +106 1 2.3278 0.505699 1.44491 -1.87805 7.24432 12.5632 +107 1 2.30107 0.0675885 2.61736 -2.34035 -25.4089 0.204635 +108 1 1.65389 0.877547 2.65941 -7.28266 6.33447 -16.1438 +109 1 3.50019 8.31721 1.47862 -16.7888 14.1081 10.898 +110 1 4.01956 0.825924 1.54962 -26.8746 12.2857 6.16059 +111 1 4.07538 0.019132 2.44171 -4.87493 0.404402 -2.17065 +112 1 2.869 0.885962 2.4149 5.17917 -2.47967 0.533766 +113 1 4.73464 0.155071 1.4932 30.6868 -26.2406 6.98684 +114 1 5.62968 0.817396 1.64834 -4.04481 -8.77462 16.8173 +115 1 5.66865 0.0141325 2.50366 17.0023 -1.89327 -13.9307 +116 1 4.86842 0.817468 2.42132 32.27 -13.4362 -6.77265 +117 1 6.59541 8.31415 1.73549 -0.21361 15.3936 4.52423 +118 1 7.59767 0.742823 1.6565 -21.3952 4.75735 -8.6823 +119 1 7.60945 8.3635 2.38741 -3.47518 -4.35582 8.08118 +120 1 6.64964 0.766964 2.59458 1.86331 7.94862 -15.7507 +121 1 0.0966564 1.72383 1.66126 -2.3646 2.96568 -2.77323 +122 1 0.838875 2.52792 1.96878 -8.15441 10.7797 -1.95863 +123 1 0.90776 1.65168 2.68747 -10.1162 -2.78056 -2.47535 +124 1 8.34426 2.2614 2.55151 21.19 -10.0612 15.2043 +125 1 1.46427 1.72978 1.76157 8.28796 -9.22695 -3.48387 +126 1 2.37501 2.29161 1.76614 -0.0664736 7.90276 1.49641 +127 1 2.67166 1.85508 2.81423 -4.33867 8.71682 -6.36279 +128 1 1.69129 2.40006 2.69001 -6.84808 74.503 -77.1336 +129 1 3.2606 1.69371 1.92128 -6.02725 -3.6159 -16.3817 +130 1 3.94104 2.38885 1.63591 5.99851 11.0997 18.049 +131 1 4.04449 1.32304 2.52718 -28.9333 17.8748 13.0885 +132 1 3.64404 2.34301 2.71879 -4.29604 2.09188 -4.97764 +133 1 4.64091 1.6418 1.58405 19.1918 -0.189122 5.88078 +134 1 5.88395 2.31133 1.52544 0.0797298 5.40617 -9.4435 +135 1 5.7987 1.64961 2.35436 -3.46325 -3.79932 12.9903 +136 1 4.78244 2.22308 2.51874 2.01011 -1.75623 -4.81914 +137 1 6.65439 1.55727 1.69251 0.0481382 -10.7878 -2.86985 +138 1 7.4609 2.22018 1.51079 9.36137 15.4008 -1.67913 +139 1 7.50576 1.63853 2.4128 -2.97032 -17.2864 -0.621812 +140 1 6.87214 2.43415 2.42038 -30.5876 3.19651 2.74052 +141 1 8.27498 3.12542 1.46263 16.9155 1.32854 13.6822 +142 1 0.778659 3.95642 1.86807 -7.25106 -12.2522 -5.40095 +143 1 0.798965 3.10856 2.99966 -8.51883 26.4353 -21.6316 +144 1 8.39629 3.85082 2.58225 -5.99614 1.48776 4.40527 +145 1 1.68381 3.21805 1.79101 -5.77633 -5.0861 7.47296 +146 1 2.56903 4.03114 1.71918 -6.92524 18.9919 2.42009 +147 1 2.68821 3.054 2.58052 -0.955464 -0.812242 -0.180548 +148 1 1.68992 4.20726 2.20027 5.368 3.11181 32.2719 +149 1 3.19042 3.29104 1.54336 50.4233 -29.9172 14.5641 +150 1 4.30208 4.0236 1.30142 -3.92395 -1.77865 11.4065 +151 1 4.28898 3.18994 2.59219 8.96711 6.3942 -10.7611 +152 1 3.60727 4.0096 2.21837 0.742083 4.13896 4.48687 +153 1 5.11886 3.09922 1.66619 -2.87182 6.36609 5.71268 +154 1 5.98984 4.3721 1.6574 7.23512 -22.1503 15.9695 +155 1 6.06757 3.38048 2.48886 -0.631751 -1.09061 1.54872 +156 1 5.04095 4.05582 2.29794 7.98224 -6.57422 -3.38111 +157 1 6.80585 3.23363 1.61955 1.81547 4.43083 5.90353 +158 1 7.6107 4.12271 1.4985 -13.6918 -18.0547 7.51636 +159 1 7.71076 3.00605 2.3508 1.14441 21.4666 -12.0177 +160 1 6.92831 4.10176 2.31565 -3.92153 2.58619 4.8482 +161 1 8.33973 5.1724 2.08404 -22.306 -14.8391 -35.8531 +162 1 0.860537 5.83051 1.79504 -25.5953 10.3696 1.23396 +163 1 0.802813 4.96181 2.52052 20.0549 -14.1798 16.2425 +164 1 8.20479 5.88748 2.7573 8.86056 43.8975 -14.7096 +165 1 1.62556 5.15881 1.79421 13.6671 -60.0224 -43.8322 +166 1 2.44832 5.82052 1.83706 -21.0979 -8.85922 15.9808 +167 1 2.35829 4.95884 2.60055 5.56499 -3.25718 -17.7316 +168 1 1.57047 5.68188 2.57793 3.26945 48.3874 60.3367 +169 1 3.12962 4.94115 1.79611 3.44797 3.66295 -7.67081 +170 1 4.533 5.88518 1.61818 -3.82507 3.84853 0.541056 +171 1 4.41047 4.91386 2.27111 -7.04817 9.97354 -0.554451 +172 1 3.1705 5.97206 2.56867 13.8835 0.36015 7.54685 +173 1 5.10201 4.84379 1.45925 -8.99072 13.7146 -7.42642 +174 1 6.04077 5.71462 1.17105 24.8221 7.94918 20.2395 +175 1 6.02655 5.34395 2.16117 8.67798 2.32994 -0.236737 +176 1 5.13754 6.13757 2.45889 -19.0768 2.88926 -22.199 +177 1 6.81157 4.98564 1.3948 -36.2833 4.79272 33.0954 +178 1 7.60086 5.99469 1.7372 -3.24829 -8.45789 -2.93345 +179 1 7.33283 5.34101 2.57932 2.07328 -12.097 -6.46632 +180 1 6.77196 6.24125 2.34214 -17.3674 -5.70799 13.1243 +181 1 0.0250537 6.6606 1.72753 8.49396 4.93702 8.33356 +182 1 0.795762 7.59079 1.77266 12.7999 -27.3678 15.1487 +183 1 0.926657 6.70523 2.69571 -0.793657 3.91691 -3.18748 +184 1 0.160908 7.59778 2.74546 -5.44053 4.97464 -19.9661 +185 1 1.54893 6.69469 1.77147 8.37496 4.15768 30.0144 +186 1 2.38553 7.66265 1.59156 1.85092 -2.31642 6.75994 +187 1 2.52893 6.74213 2.34554 9.20138 12.1517 -25.6716 +188 1 1.80175 7.4451 2.61158 -6.78811 17.5009 -13.1399 +189 1 3.38458 6.74038 1.57533 -10.1646 -3.59545 3.61897 +190 1 4.095 7.47851 1.58866 27.0187 15.4009 2.51878 +191 1 4.11379 6.83 2.37783 19.5598 -18.1657 -14.1463 +192 1 3.12959 7.71074 2.36405 10.6634 -2.49932 -15.2866 +193 1 5.08729 6.94297 1.62592 -21.1801 -24.4484 5.07107 +194 1 5.73581 7.71377 1.57745 5.16642 11.3097 -0.890489 +195 1 5.92001 7.08484 2.45291 -0.193261 -0.933403 -1.70059 +196 1 4.83819 7.59024 2.39768 8.18574 14.9342 11.0206 +197 1 6.61545 6.66525 1.38958 -18.6406 -25.8802 -11.2439 +198 1 7.15994 7.45994 1.57935 11.6501 4.19084 33.778 +199 1 7.56748 6.9114 2.40976 10.0926 4.81165 9.43494 +200 1 6.80428 7.72449 2.78938 -1.24224 -1.60677 -10.8659 +201 1 0.159784 0.136544 3.24366 -1.32953 4.05967 1.66335 +202 1 1.00698 0.811307 3.51207 1.50245 1.78035 6.01503 +203 1 1.34713 0.12551 4.66914 -24.521 -31.0514 3.16868 +204 1 0.0655245 0.668593 4.25847 -0.855275 2.59789 -3.35749 +205 1 1.74942 8.37675 3.57933 -10.207 -16.1779 -1.21978 +206 1 2.26863 0.82911 3.48792 22.6881 17.8048 9.09595 +207 1 2.33553 0.183914 4.4711 16.8323 -1.13179 -15.08 +208 1 1.7049 1.03332 4.4695 6.78822 33.3459 -7.07653 +209 1 3.29237 0.411287 3.32326 -2.12858 -4.79866 -0.866625 +210 1 4.21141 0.796867 3.72276 15.2258 15.2508 -15.0202 +211 1 4.33441 8.33993 4.30342 13.6521 7.25398 3.1725 +212 1 3.45786 0.725922 4.42039 -13.4693 -6.1715 4.46767 +213 1 4.89231 0.0473082 3.15782 -6.25621 1.30634 20.3282 +214 1 5.77362 0.736119 3.37748 -9.09312 1.23928 -13.4649 +215 1 5.99071 8.04065 4.47949 -15.8189 13.2428 -8.46949 +216 1 5.196 0.682234 4.2587 4.7081 -6.90451 -0.266688 +217 1 6.57106 0.145322 3.40637 19.3462 -23.2913 17.9258 +218 1 7.59401 0.663732 3.46257 -2.8602 2.11131 -2.24016 +219 1 7.44242 8.25412 4.2449 1.11307 19.9225 9.74876 +220 1 6.62382 0.709572 4.35284 3.66026 3.16927 -3.64727 +221 1 0.0779483 1.38159 3.37319 -4.4953 5.38733 3.01304 +222 1 0.974278 2.30233 3.53228 -23.5961 -13.9704 29.7447 +223 1 0.524182 1.77379 4.53785 8.44119 -12.0369 -19.76 +224 1 8.32657 2.54461 4.19453 11.685 -8.01921 4.29442 +225 1 1.79699 1.78778 3.36592 20.9053 -94.2146 75.3552 +226 1 2.26904 2.65097 3.69138 3.64635 0.74501 -3.21688 +227 1 2.67429 1.70202 4.43144 -1.62218 -6.52331 -3.16444 +228 1 1.67869 2.25152 4.52595 21.8057 -26.9163 -24.6655 +229 1 3.42529 1.64095 3.50559 7.24234 -14.969 7.63922 +230 1 4.36843 2.51227 3.48596 2.07064 -5.87084 11.4812 +231 1 4.83369 1.71242 4.31187 -12.4342 -5.24453 -2.55025 +232 1 3.42697 2.55135 4.03879 13.1661 -11.4647 -6.22039 +233 1 5.09889 1.5127 3.30322 -10.1348 7.40169 -7.59726 +234 1 6.05204 2.45182 3.35855 -5.34479 4.21286 -4.99107 +235 1 5.91247 1.54121 4.03978 -1.19872 3.24833 9.47786 +236 1 5.34566 2.59829 4.30389 3.31953 7.26855 -16.7286 +237 1 6.74657 1.65018 3.27179 -23.12 -29.0051 -3.67746 +238 1 7.53263 2.23686 3.30386 26.344 22.8452 7.39879 +239 1 7.49613 1.58204 4.21155 10.9589 -18.8504 -4.35663 +240 1 6.70452 2.2326 4.19472 -13.7578 19.073 -7.70781 +241 1 8.04948 3.18864 3.48276 7.81989 17.0755 -15.6642 +242 1 0.420364 4.02026 3.62891 2.0762 -18.0048 -13.8871 +243 1 1.02911 3.20723 4.10028 2.87528 5.61338 3.46722 +244 1 8.23518 4.59996 4.24867 -9.72892 -14.3069 11.6196 +245 1 1.79813 3.62221 3.14835 -2.38332 -26.1643 0.00682256 +246 1 2.74246 4.09054 3.06778 10.2172 -0.241531 -5.01738 +247 1 2.65108 3.56469 4.0066 1.29528 2.95166 -0.450344 +248 1 1.68753 4.16642 4.41008 0.531244 0.36282 -0.905409 +249 1 3.56157 3.26659 3.34031 -15.156 16.0178 -13.2173 +250 1 4.30786 4.20161 3.07587 -3.71718 9.6458 -20.0534 +251 1 4.29173 3.71129 3.93288 2.63232 -25.6185 20.4798 +252 1 3.34785 4.41255 3.95574 4.30294 0.337698 1.30747 +253 1 5.19196 3.15058 3.27975 2.68017 7.34728 -0.723223 +254 1 6.11836 4.37563 3.09786 3.48097 -0.455645 -7.15348 +255 1 6.16379 3.4966 3.8024 -0.493793 0.0328113 2.1336 +256 1 5.30251 4.52711 3.80393 -16.2632 -25.1941 -0.0075048 +257 1 7.08947 3.30091 3.10932 -23.6486 5.19633 4.56168 +258 1 7.44697 4.43668 3.27896 -0.511887 -2.93371 -0.292771 +259 1 7.26132 3.68038 4.11877 19.5278 5.77559 -31.2062 +260 1 6.65227 4.59556 4.02535 -2.98634 0.729124 1.77093 +261 1 8.32438 5.07972 3.31456 7.45197 -18.3523 8.49382 +262 1 0.7239 5.87238 3.35063 13.9037 -7.68163 -11.6827 +263 1 0.86133 4.86733 4.0112 5.23908 17.06 9.33784 +264 1 0.110376 5.99228 4.15088 -19.5006 -5.14624 15.1727 +265 1 1.63326 4.60922 3.31023 -1.76723 17.8491 2.08855 +266 1 2.40135 5.61695 3.38494 19.4662 4.44663 -11.3673 +267 1 2.36184 5.08435 4.31966 -1.81965 -14.9274 -8.60789 +268 1 1.71701 5.94552 4.03684 -24.0402 -0.0953197 5.79012 +269 1 3.43912 4.9954 2.79577 7.89838 -10.7079 17.2388 +270 1 4.22838 5.86109 3.02821 33.6181 3.37383 -45.0173 +271 1 4.24887 5.06359 3.71273 2.64953 -0.546445 2.15952 +272 1 3.55742 5.92395 3.71083 -38.5919 -3.44905 39.4056 +273 1 5.41837 5.23828 2.98577 -11.447 -4.74628 10.7983 +274 1 5.86494 6.22754 3.11739 14.9731 7.40151 22.8162 +275 1 5.75467 5.37436 4.08221 13.6205 23.921 6.83069 +276 1 4.77382 6.13694 3.95439 -2.74813 -13.8938 10.4295 +277 1 6.55906 5.4789 3.24844 0.234698 -8.05013 11.4476 +278 1 7.53331 6.151 3.48116 -10.0459 9.16913 -20.7264 +279 1 7.59712 5.40949 4.12314 -10.2706 -23.4933 17.211 +280 1 6.76315 6.15422 4.20451 -8.32818 -2.13306 4.306 +281 1 8.33074 6.79274 3.30017 10.9969 -9.86444 14.3566 +282 1 1.03943 7.60681 3.41422 12.8839 -22.0033 7.43641 +283 1 0.876997 6.68124 4.1033 12.4942 12.9257 -7.86127 +284 1 0.320289 7.62896 4.11358 -19.9566 8.93301 7.64028 +285 1 2.12233 6.73507 3.25947 -6.36672 -13.9408 34.1069 +286 1 2.9278 7.71082 3.35699 -9.10575 13.9767 3.53664 +287 1 2.86555 6.96099 4.04549 -8.29151 -16.9355 4.68952 +288 1 1.89553 7.49272 4.25249 -6.95602 2.25366 -4.36835 +289 1 3.55128 6.82828 3.17739 -22.1877 4.18931 17.356 +290 1 4.1661 7.71123 3.4095 -5.10369 -4.69259 -0.796458 +291 1 3.89274 6.87937 4.19693 15.4298 1.82254 7.44647 +292 1 3.39266 7.95134 4.30177 -1.7872 -21.2114 -27.9517 +293 1 4.99714 6.86548 3.27273 -3.15325 15.5146 -9.80269 +294 1 5.7604 7.67976 3.37293 2.05238 1.22428 3.6757 +295 1 5.73479 6.76996 4.15088 6.33474 -4.66485 -1.392 +296 1 5.07616 7.57695 4.40446 -13.6351 -7.42167 0.514113 +297 1 6.73778 6.81794 3.33301 -3.54485 0.402493 -5.08336 +298 1 7.71498 7.67053 3.44695 -0.752689 -3.6099 -11.6949 +299 1 7.71759 6.87965 4.22182 -5.11403 5.07303 3.22293 +300 1 6.7649 7.45476 4.17956 6.56157 -12.3801 -0.724651 +301 1 8.19197 0.136233 5.17288 2.67067 20.6746 -19.9914 +302 1 0.776102 0.931351 5.08619 -1.70464 -8.91233 1.85235 +303 1 0.888781 0.0179834 5.65999 -4.55543 21.0031 13.534 +304 1 8.38466 0.737331 6.00004 -6.63761 5.81892 -3.68334 +305 1 2.17326 8.16764 5.48567 -30.0571 8.40977 9.50779 +306 1 2.68565 0.975823 5.34104 11.1467 5.8174 -19.2362 +307 1 3.06444 0.336871 6.1128 1.74673 -5.08128 15.5867 +308 1 1.94778 0.751629 6.0231 -12.5402 -6.77103 11.9096 +309 1 3.09215 -0.0018856 5.12048 23.3711 9.80891 31.3016 +310 1 4.54285 0.96074 5.03055 -10.8439 -8.47943 8.00065 +311 1 4.19772 8.25187 6.2874 -2.87662 7.25597 -11.3947 +312 1 3.73883 1.45482 5.73884 -5.31372 -3.16529 -7.8226 +313 1 5.15615 8.35466 5.42348 2.42368 -1.79965 -6.24325 +314 1 5.91471 0.891384 5.15303 -5.07011 -3.09253 -0.460458 +315 1 6.03745 8.35632 6.14961 -1.39208 3.8678 -5.18235 +316 1 5.2121 0.86593 5.98804 -13.8254 0.446509 -12.536 +317 1 6.68868 8.34181 5.14194 3.9888 6.48649 16.9974 +318 1 7.34021 0.809849 5.26372 -2.78853 -11.1974 -10.3326 +319 1 7.36245 8.30575 6.05369 1.98185 25.0408 -10.0092 +320 1 6.64158 0.85851 5.99168 -3.68623 1.19752 6.36998 +321 1 8.13309 1.40671 5.10096 17.8835 4.45702 -4.02515 +322 1 0.892662 2.59499 5.00421 -20.8235 21.437 24.4928 +323 1 0.773043 1.57142 5.91415 4.22614 9.86073 2.56515 +324 1 8.33239 2.57823 5.60038 -0.623629 0.0892147 1.2306 +325 1 1.87225 1.66498 5.43985 -2.48264 -4.0236 -4.58226 +326 1 2.75473 2.72259 4.73435 -30.311 11.1987 -1.55273 +327 1 2.93165 2.12687 5.49641 -1.73472 -35.7803 16.6222 +328 1 1.7335 2.58373 5.90704 -3.71318 12.7214 1.30751 +329 1 3.77896 1.69526 4.65032 1.63977 11.6216 2.36832 +330 1 4.33882 2.78478 4.62298 7.45227 7.00188 -24.1667 +331 1 4.0935 2.44339 5.52545 -11.3615 -7.17888 20.8862 +332 1 3.18285 3.03749 5.86709 11.7107 14.2608 -10.1303 +333 1 5.16253 1.77254 5.33362 4.38648 8.73211 2.03951 +334 1 5.9743 2.78241 5.0854 16.8461 0.569184 7.37091 +335 1 6.05449 1.8557 6.00418 -1.07841 -2.85482 0.754485 +336 1 5.02736 2.93607 5.49369 -0.394928 -5.32288 -0.0457358 +337 1 6.65738 1.68333 5.09298 2.04945 -3.50949 1.46808 +338 1 7.506 2.4535 4.81544 -2.36267 6.50792 21.426 +339 1 7.5049 1.81157 5.81254 2.0705 -7.66144 9.63716 +340 1 6.81799 2.57614 5.74327 -5.22025 12.4071 0.584392 +341 1 8.08209 3.4329 4.82809 -0.388102 0.733533 -0.302449 +342 1 0.687603 4.05264 4.91973 13.3113 7.10483 -26.1293 +343 1 0.927182 3.40713 5.70883 1.42 -2.21252 8.41121 +344 1 8.39125 4.08596 5.64374 -17.7983 3.69834 21.9629 +345 1 1.85335 3.18328 4.91159 -22.5662 10.1648 8.61749 +346 1 2.62594 3.83741 5.0269 -11.5374 29.2389 12.1219 +347 1 2.23001 3.64598 5.99431 12.2251 -19.0314 6.6066 +348 1 1.61612 4.36322 5.62412 -4.72812 -41.6645 3.65456 +349 1 3.49026 3.4159 4.80384 34.5623 1.92174 -9.26957 +350 1 4.42781 4.48169 4.58587 2.89283 12.0072 14.2383 +351 1 4.32987 3.73273 5.40213 -1.15236 0.923586 4.29704 +352 1 3.35747 3.99106 6.24745 4.6285 19.5949 -5.94829 +353 1 5.1733 3.66262 4.57851 -0.760359 -3.40804 -5.73178 +354 1 5.75745 4.60154 4.93992 12.48 38.3619 -39.183 +355 1 5.60952 3.84508 5.51193 1.72033 -36.6996 37.1733 +356 1 4.90838 4.64872 5.58962 -7.33472 10.9707 -1.22542 +357 1 6.81366 3.55073 4.97382 -24.7572 -16.3635 34.7513 +358 1 7.36231 4.42367 5.08055 17.1166 2.62568 -2.95463 +359 1 7.4725 3.41969 5.92572 4.71216 -0.444272 -3.67252 +360 1 6.56495 4.37474 5.82163 -0.033274 -9.82017 -6.2351 +361 1 0.041011 5.18659 5.08838 -22.5443 6.51501 -27.8507 +362 1 1.02655 6.1046 4.9959 -2.55187 -8.42255 -9.06362 +363 1 0.725543 4.91454 5.73466 12.2313 -2.94426 20.5318 +364 1 0.0422288 5.86356 5.87032 0.0942915 12.4442 -1.56822 +365 1 1.61098 5.19782 5.1268 2.44581 33.2387 -21.9348 +366 1 2.65636 5.69092 5.09384 11.8609 0.215073 14.2086 +367 1 2.6104 4.85981 5.98721 5.66035 -5.70161 -4.77737 +368 1 1.90538 6.1737 5.70769 -41.2624 -24.39 16.3086 +369 1 3.46858 4.77582 5.16944 -0.707582 -1.43422 0.766057 +370 1 3.76426 5.90532 4.89181 3.4437 -1.11423 -2.15979 +371 1 4.07073 4.92867 6.32743 11.4607 -11.4553 -4.32634 +372 1 3.67793 5.86643 6.05942 -4.35866 5.03724 -1.47182 +373 1 4.98792 5.51389 4.93524 -8.4187 -10.8933 -4.11136 +374 1 5.89023 6.01641 5.05179 11.0493 7.97987 -0.316877 +375 1 5.84913 5.21289 5.8287 7.09495 5.60009 -11.1489 +376 1 4.95887 5.92462 6.03819 -1.41241 -1.47294 -8.90972 +377 1 6.72618 5.24569 4.87739 -4.6501 10.2679 6.06598 +378 1 7.69701 6.07801 4.9728 1.45309 -5.4044 1.15049 +379 1 7.57443 5.25318 5.8022 -4.19719 -6.86637 2.5693 +380 1 6.75672 5.96198 5.84181 4.25859 -4.73277 0.116077 +381 1 0.149236 6.9327 4.88187 0.301354 -7.8021 16.5737 +382 1 1.06612 7.54377 5.19235 6.17987 -18.0682 -12.1896 +383 1 0.908663 6.67909 5.83913 1.89859 7.5565 8.00921 +384 1 8.3967 7.73373 5.73713 17.5958 -22.201 25.7152 +385 1 2.09262 6.53099 4.7967 1.84262 19.7267 -15.5304 +386 1 2.6809 7.4184 4.97144 1.84587 -3.02643 6.66108 +387 1 2.76451 6.5131 6.02372 26.4927 9.3308 7.09081 +388 1 1.89235 7.21971 6.07993 -5.61302 23.442 -46.1583 +389 1 3.56452 6.91614 5.29782 1.29026 -2.451 2.37678 +390 1 4.22056 7.80764 5.23329 -2.48711 -3.82055 1.83806 +391 1 4.29263 6.77471 6.12925 7.35038 5.5119 -5.7056 +392 1 2.85273 7.60961 6.07343 16.4578 1.27697 -7.39815 +393 1 4.81773 6.56695 4.97715 -1.40117 8.33727 3.10183 +394 1 5.78811 7.39325 5.43254 7.66799 3.74746 -17.7564 +395 1 5.91597 6.55237 6.07292 -10.3134 0.875812 3.19143 +396 1 5.1536 7.54901 6.2302 -8.62748 1.72241 13.4381 +397 1 6.84976 6.76387 5.09828 -3.19969 2.83039 -4.79256 +398 1 7.54117 7.72913 5.1763 -12.4453 -25.3207 -11.2598 +399 1 7.70324 6.72981 5.83369 -19.5261 3.79708 -10.3274 +400 1 6.77336 7.41197 5.93794 -9.93531 -0.946567 -12.2979 +401 1 8.22949 8.35705 6.76928 1.64244 -1.45449 1.77988 +402 1 0.72004 0.832942 6.72959 22.4465 -5.361 -6.29847 +403 1 0.883022 0.0931191 7.57241 -5.23405 -15.4407 -5.32038 +404 1 0.0468789 0.82113 7.48906 -16.6351 2.71194 14.972 +405 1 2.03902 8.21121 6.63645 7.11775 -8.1199 -7.72414 +406 1 2.8098 1.35985 6.35749 11.4457 2.58538 -2.95276 +407 1 2.39096 8.06897 7.6788 1.19633 7.68608 5.18448 +408 1 1.75996 0.580686 7.28683 6.89284 15.6237 4.36189 +409 1 3.24708 7.93738 6.98795 5.84043 19.9452 -24.3758 +410 1 4.23919 0.919929 6.46503 -1.07654 -9.91612 -5.08402 +411 1 3.90772 0.424381 7.41946 37.0812 -23.6824 -3.45202 +412 1 2.91871 0.505987 7.33506 -26.0302 7.74114 -11.0468 +413 1 4.92803 0.11282 7.09764 -8.28234 1.33652 -4.84063 +414 1 5.89475 1.0043 6.70526 7.29393 0.830325 27.9656 +415 1 5.8956 8.35718 7.44426 -3.02776 0.024361 13.8614 +416 1 4.71342 1.28665 7.29701 10.263 5.35948 11.5905 +417 1 6.8248 0.0574117 7.01961 11.7828 1.29904 -9.90689 +418 1 7.52034 1.04303 6.65362 -4.17639 -6.17679 3.43381 +419 1 7.73603 8.17986 7.79994 1.7859 4.36245 -17.9939 +420 1 7.13318 0.752429 7.78463 13.3591 3.5282 -5.71599 +421 1 8.39243 1.66394 6.67161 -0.134672 7.39125 4.10576 +422 1 0.854509 2.49412 6.65204 0.887161 -2.38052 0.586225 +423 1 1.18138 1.63924 7.31791 -41.6971 -18.352 25.0151 +424 1 0.0943458 2.334 7.66786 0.324396 10.57 -15.5201 +425 1 1.87867 1.74452 6.645 -1.95754 3.46436 -44.2754 +426 1 2.63684 2.47303 6.52845 -8.45632 -20.7999 4.28943 +427 1 2.51699 1.47554 7.37579 1.92109 3.65888 22.6814 +428 1 1.82876 2.39767 7.50566 14.4123 21.9409 0.136363 +429 1 3.78398 2.21463 6.57246 -2.68631 2.13236 -0.792617 +430 1 4.46308 3.07592 6.43555 -3.89191 7.33892 -9.13636 +431 1 3.59875 1.35397 7.20413 -9.98874 22.9069 2.08665 +432 1 3.19396 2.3577 7.56493 -2.6719 3.09783 -0.16421 +433 1 5.06299 2.1644 6.37533 -2.58633 -2.00836 2.79809 +434 1 5.67119 3.15784 6.34996 -0.566548 -6.83481 -5.10746 +435 1 5.66575 1.97666 7.57441 -14.7077 -20.3342 4.08546 +436 1 4.67442 2.64884 7.36908 -6.67424 -36.8328 0.644107 +437 1 6.68154 1.59605 7.24042 -18.9747 -1.14386 -19.0037 +438 1 7.52504 2.47849 6.70825 -1.30537 -8.16455 -5.2397 +439 1 7.60687 1.7083 7.61907 22.0172 -9.53549 -2.5479 +440 1 6.29708 2.66318 7.23348 12.1765 11.0009 -15.9537 +441 1 0.116615 3.32613 6.70965 -8.35482 -2.36763 -31.1169 +442 1 0.754871 4.30259 6.64315 -6.49201 3.33528 -9.76479 +443 1 0.673999 3.30917 7.54182 21.55 -11.008 11.6004 +444 1 8.2904 4.07274 7.4316 9.5379 25.3171 7.28976 +445 1 1.3832 3.4915 6.68441 -1.24784 -22.5622 2.29536 +446 1 2.09272 4.19927 6.89939 7.14914 10.3433 -0.646722 +447 1 2.38812 3.48925 7.75082 -1.53849 -4.15299 -0.56146 +448 1 0.98545 4.31304 7.66307 5.8465 7.34467 12.6645 +449 1 3.01955 3.30623 6.95327 13.2113 8.86686 7.49164 +450 1 4.09943 3.91395 7.09298 -2.48303 5.76893 1.33505 +451 1 4.01094 3.20608 7.89765 -2.70921 2.34384 1.12391 +452 1 3.37728 4.06259 7.97546 3.1883 6.31048 -16.9835 +453 1 4.95274 4.06193 6.44472 -50.262 -12.0969 -14.4258 +454 1 5.82886 4.19415 6.78586 51.8922 14.3443 21.8961 +455 1 5.38346 3.34165 7.34475 16.015 22.8896 8.36611 +456 1 5.08561 4.4601 7.63447 17.0994 -9.93497 -11.4722 +457 1 6.63523 3.51978 6.68288 11.156 -6.22589 -13.2585 +458 1 7.56324 4.26511 6.59456 -1.25309 2.63878 0.745103 +459 1 7.65852 3.28844 7.34661 -10.7372 -4.25374 3.64969 +460 1 6.81691 4.07739 7.53042 5.20496 31.087 -1.8792 +461 1 0.0305913 5.07954 6.63961 -13.4152 -0.334577 -15.0347 +462 1 0.755373 5.9128 6.63716 6.29428 -4.8245 9.83099 +463 1 0.228688 5.17338 7.63443 6.77209 -15.3569 2.77515 +464 1 0.0239769 6.1789 7.50959 5.71025 13.0173 8.45368 +465 1 1.62736 5.16876 6.26262 -1.95267 15.3222 16.2267 +466 1 2.58882 5.57631 6.81228 -21.3734 15.7914 -12.1527 +467 1 2.44828 4.86387 7.63128 0.635145 -14.9061 -0.714387 +468 1 1.59901 5.57209 7.51534 -11.1496 -3.28487 -5.03165 +469 1 3.34619 4.96263 7.08932 17.4571 -30.3367 -0.525226 +470 1 4.2543 5.71212 7.1129 9.72931 3.13017 -7.54215 +471 1 4.20945 4.90695 7.86069 -23.7666 -21.5851 -7.20856 +472 1 3.30097 5.87496 7.52978 -1.62077 18.6793 20.7743 +473 1 5.31869 5.1825 6.70313 -6.70115 -5.30598 20.424 +474 1 6.1285 5.9705 7.04356 -55.8752 -30.7828 -22.045 +475 1 6.19989 5.01385 7.64593 -24.2843 -27.8512 -0.0723503 +476 1 5.23737 5.71302 7.75618 7.88564 -2.82129 -5.95862 +477 1 6.57282 5.00818 6.64579 3.73801 7.56977 2.57742 +478 1 7.65968 6.07456 6.846 -10.6673 -6.72159 -16.2973 +479 1 7.41458 5.08419 7.34751 2.79575 -2.58892 1.26995 +480 1 6.72257 5.83109 7.80136 50.7146 16.6992 29.5346 +481 1 0.0723308 6.76891 6.47705 11.6111 8.10298 22.8191 +482 1 1.02933 7.74537 6.50218 -6.26193 -3.88943 1.15511 +483 1 0.947055 6.70337 7.58592 -5.51835 -14.0139 4.24362 +484 1 0.0848928 7.36532 7.45176 -1.87156 3.22591 1.0451 +485 1 1.56902 6.60766 6.76327 -14.013 -31.9293 15.0177 +486 1 2.40361 7.17234 6.95829 30.5527 12.991 8.35655 +487 1 2.29885 6.36291 7.58786 1.80834 5.53646 4.44151 +488 1 1.553 7.54602 7.43994 -8.27629 2.11355 -7.51923 +489 1 3.47111 6.73135 6.78593 -6.0772 1.66346 11.0677 +490 1 4.24975 7.49747 6.97664 2.8759 -9.15152 10.7243 +491 1 4.10179 6.68273 7.72108 -3.71491 1.8557 -11.1514 +492 1 3.18945 7.41445 7.81539 11.7129 -34.8369 22.2868 +493 1 5.09069 6.56162 6.92242 0.709322 1.72009 4.70344 +494 1 6.15914 7.53992 6.80488 -4.25562 -6.4834 8.29409 +495 1 6.17817 6.79535 7.72789 -19.4606 -0.130997 -26.8387 +496 1 5.10104 7.47088 7.65047 -2.76834 -2.47532 -11.4779 +497 1 6.74018 6.65599 6.74814 32.1985 25.9827 -14.7809 +498 1 7.41102 7.54832 6.72723 12.7336 -14.2037 26.5422 +499 1 7.28837 6.72521 7.66327 11.2322 2.95469 4.78999 +500 1 6.81386 7.67069 7.84231 -16.9841 5.08288 -4.95949 diff --git a/examples/mdi/dump.17Jun22.snapshot.driver.mpi.4 b/examples/mdi/dump.17Jun22.snapshot.driver.mpi.4 new file mode 100644 index 0000000000..db50370991 --- /dev/null +++ b/examples/mdi/dump.17Jun22.snapshot.driver.mpi.4 @@ -0,0 +1,2036 @@ +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +500 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +ITEM: ATOMS id type x y z f_2[1] f_2[2] f_2[3] +1 1 0 0 0 -1.06581e-14 -1.13243e-14 -1.09635e-14 +2 1 0.839798 0.839798 0 2.88658e-15 3.34455e-15 -9.76996e-15 +3 1 0.839798 0 0.839798 2.66454e-15 -9.65894e-15 4.45477e-15 +4 1 0 0.839798 0.839798 -1.15463e-14 2.88658e-15 3.44169e-15 +5 1 1.6796 0 0 -3.95517e-16 -1.06581e-14 -1.11022e-14 +6 1 2.51939 0.839798 0 -3.1225e-16 2.66454e-15 -9.76996e-15 +7 1 2.51939 0 0.839798 -7.97973e-16 -1.06581e-14 2.88658e-15 +8 1 1.6796 0.839798 0.839798 -4.3715e-16 3.10862e-15 3.1225e-15 +9 1 3.35919 0 0 1.30798e-14 -1.06581e-14 -1.06581e-14 +10 1 4.19899 0.839798 0 -2.24404e-14 2.66454e-15 -8.88178e-15 +11 1 4.19899 0 0.839798 -2.33424e-14 -8.88178e-15 2.55351e-15 +12 1 3.35919 0.839798 0.839798 1.37182e-14 3.10862e-15 4.23273e-15 +13 1 5.03879 0 0 3.19189e-16 -7.99361e-15 -7.10543e-15 +14 1 5.87859 0.839798 0 2.27665e-14 2.88658e-15 -7.99361e-15 +15 1 5.87859 0 0.839798 2.17673e-14 -7.99361e-15 2.77556e-15 +16 1 5.03879 0.839798 0.839798 -4.09395e-16 2.88658e-15 2.90046e-15 +17 1 6.71838 0 0 -3.21965e-15 -9.63118e-15 -1.01863e-14 +18 1 7.55818 0.839798 0 4.44089e-16 2.58127e-15 -9.10383e-15 +19 1 7.55818 0 0.839798 -4.44089e-16 -9.99201e-15 3.21965e-15 +20 1 6.71838 0.839798 0.839798 -2.94209e-15 2.90046e-15 4.02456e-15 +21 1 0 1.6796 0 -1.15463e-14 0 -1.04361e-14 +22 1 0.839798 2.51939 0 3.10862e-15 -9.71445e-17 -1.00198e-14 +23 1 0.839798 1.6796 0.839798 2.33147e-15 2.22045e-16 3.34455e-15 +24 1 0 2.51939 0.839798 -1.06581e-14 -7.21645e-16 2.9976e-15 +25 1 1.6796 1.6796 0 -4.23273e-16 6.93889e-18 -8.88178e-15 +26 1 2.51939 2.51939 0 -2.19963e-15 -1.77636e-15 -1.09079e-14 +27 1 2.51939 1.6796 0.839798 -1.2837e-15 9.08995e-16 2.88658e-15 +28 1 1.6796 2.51939 0.839798 3.53884e-16 -2.0331e-15 2.8727e-15 +29 1 3.35919 1.6796 0 1.351e-14 1.45717e-16 -7.99361e-15 +30 1 4.19899 2.51939 0 -2.32314e-14 -1.88738e-15 -9.99201e-15 +31 1 4.19899 1.6796 0.839798 -2.24404e-14 -2.08167e-16 3.33067e-15 +32 1 3.35919 2.51939 0.839798 1.45925e-14 -1.36002e-15 3.31679e-15 +33 1 5.03879 1.6796 0 2.28983e-16 1.94289e-16 -7.99361e-15 +34 1 5.87859 2.51939 0 2.13649e-14 -1.66533e-15 -8.21565e-15 +35 1 5.87859 1.6796 0.839798 1.98383e-14 1.17961e-15 3.10862e-15 +36 1 5.03879 2.51939 0.839798 3.40006e-16 -2.80331e-15 2.8727e-15 +37 1 6.71838 1.6796 0 -2.88658e-15 -2.63678e-16 -8.99281e-15 +38 1 7.55818 2.51939 0 1.33227e-15 -1.33227e-15 -9.99201e-15 +39 1 7.55818 1.6796 0.839798 -8.04912e-16 1.94289e-16 3.33067e-15 +40 1 6.71838 2.51939 0.839798 -3.10862e-15 -1.66533e-15 3.55271e-15 +41 1 0 3.35919 0 -1.06581e-14 1.31006e-14 -1.02141e-14 +42 1 0.839798 4.19899 0 2.66454e-15 -2.27873e-14 -9.34669e-15 +43 1 0.839798 3.35919 0.839798 2.33147e-15 1.43774e-14 4.01068e-15 +44 1 0 4.19899 0.839798 -9.76996e-15 -2.33147e-14 2.60902e-15 +45 1 1.6796 3.35919 0 -8.11851e-16 1.5099e-14 -1.02141e-14 +46 1 2.51939 4.19899 0 -1.89432e-15 -2.39808e-14 -7.54952e-15 +47 1 2.51939 3.35919 0.839798 -5.06539e-16 1.51268e-14 3.44169e-15 +48 1 1.6796 4.19899 0.839798 -4.16334e-16 -2.30926e-14 3.10862e-15 +49 1 3.35919 3.35919 0 1.26774e-14 1.46549e-14 -9.32587e-15 +50 1 4.19899 4.19899 0 -2.30302e-14 -2.4869e-14 -7.10543e-15 +51 1 4.19899 3.35919 0.839798 -2.21004e-14 1.13798e-14 2.77556e-15 +52 1 3.35919 4.19899 0.839798 1.18308e-14 -2.22045e-14 2.66454e-15 +53 1 5.03879 3.35919 0 6.93889e-17 1.13243e-14 -7.54952e-15 +54 1 5.87859 4.19899 0 2.21975e-14 -2.22045e-14 -6.43929e-15 +55 1 5.87859 3.35919 0.839798 2.14412e-14 1.27398e-14 2.77556e-15 +56 1 5.03879 4.19899 0.839798 -2.22045e-16 -2.13163e-14 2.72005e-15 +57 1 6.71838 3.35919 0 -3.38618e-15 1.34892e-14 -9.15934e-15 +58 1 7.55818 4.19899 0 0 -2.35367e-14 -7.32747e-15 +59 1 7.55818 3.35919 0.839798 1.11022e-16 1.39888e-14 3.10862e-15 +60 1 6.71838 4.19899 0.839798 -2.9976e-15 -2.31204e-14 2.34535e-15 +61 1 0 5.03879 0 -6.21725e-15 -2.22045e-16 -7.32747e-15 +62 1 0.839798 5.87859 0 2.44249e-15 2.22322e-14 -7.10543e-15 +63 1 0.839798 5.03879 0.839798 2.55351e-15 -1.66533e-16 2.61596e-15 +64 1 0 5.87859 0.839798 -7.10543e-15 2.15938e-14 3.10862e-15 +65 1 1.6796 5.03879 0 1.249e-16 4.44089e-16 -7.99361e-15 +66 1 2.51939 5.87859 0 -1.73472e-15 2.16008e-14 -7.99361e-15 +67 1 2.51939 5.03879 0.839798 -1.7833e-15 6.66134e-16 3.04617e-15 +68 1 1.6796 5.87859 0.839798 4.16334e-17 2.04697e-14 3.33067e-15 +69 1 3.35919 5.03879 0 1.08802e-14 0 -8.02136e-15 +70 1 4.19899 5.87859 0 -2.37727e-14 2.2253e-14 -6.21725e-15 +71 1 4.19899 5.03879 0.839798 -1.93734e-14 2.22045e-16 3.26822e-15 +72 1 3.35919 5.87859 0.839798 1.27537e-14 2.2593e-14 3.33067e-15 +73 1 5.03879 5.03879 0 1.94289e-16 6.66134e-16 -5.32907e-15 +74 1 5.87859 5.87859 0 2.20449e-14 2.1233e-14 -6.21725e-15 +75 1 5.87859 5.03879 0.839798 1.92277e-14 4.44089e-16 2.82413e-15 +76 1 5.03879 5.87859 0.839798 -6.93889e-18 2.00326e-14 3.33067e-15 +77 1 6.71838 5.03879 0 -2.27596e-15 -4.16334e-17 -8.24341e-15 +78 1 7.55818 5.87859 0 -8.88178e-16 2.33147e-14 -7.54952e-15 +79 1 7.55818 5.03879 0.839798 8.32667e-16 1.88738e-15 2.55351e-15 +80 1 6.71838 5.87859 0.839798 -3.16414e-15 2.25098e-14 3.1225e-15 +81 1 0 6.71838 0 -9.76996e-15 -3.77476e-15 -9.38138e-15 +82 1 0.839798 7.55818 0 2.22045e-15 1.67921e-15 -9.20097e-15 +83 1 0.839798 6.71838 0.839798 2.33147e-15 -2.83107e-15 3.58047e-15 +84 1 0 7.55818 0.839798 -7.99361e-15 -1.11022e-15 3.05311e-15 +85 1 1.6796 6.71838 0 1.38778e-16 -2.72005e-15 -8.99281e-15 +86 1 2.51939 7.55818 0 -2.69229e-15 1.55431e-15 -8.43769e-15 +87 1 2.51939 6.71838 0.839798 -7.91034e-16 -2.83801e-15 3.56659e-15 +88 1 1.6796 7.55818 0.839798 4.64906e-16 -5.55112e-17 3.10862e-15 +89 1 3.35919 6.71838 0 1.27398e-14 -2.10942e-15 -8.04912e-15 +90 1 4.19899 7.55818 0 -2.46053e-14 -2.22045e-16 -6.21725e-15 +91 1 4.19899 6.71838 0.839798 -2.40225e-14 -4.89886e-15 2.67841e-15 +92 1 3.35919 7.55818 0.839798 1.36349e-14 -5.55112e-17 2.66454e-15 +93 1 5.03879 6.71838 0 3.19189e-16 -3.71925e-15 -7.32747e-15 +94 1 5.87859 7.55818 0 2.2593e-14 0 -7.10543e-15 +95 1 5.87859 6.71838 0.839798 2.19269e-14 -2.62984e-15 2.45637e-15 +96 1 5.03879 7.55818 0.839798 -4.16334e-16 -8.32667e-17 2.05391e-15 +97 1 6.71838 6.71838 0 -2.60902e-15 -2.42861e-15 -7.99361e-15 +98 1 7.55818 7.55818 0 -4.44089e-16 -8.88178e-16 -8.88178e-15 +99 1 7.55818 6.71838 0.839798 -1.66533e-16 -2.22045e-15 2.55351e-15 +100 1 6.71838 7.55818 0.839798 -3.16414e-15 2.77556e-17 2.78944e-15 +101 1 0 0 1.6796 -1.15463e-14 -1.04361e-14 -8.88178e-16 +102 1 0.839798 0.839798 1.6796 2.44249e-15 2.56739e-15 6.66134e-16 +103 1 0.839798 0 2.51939 2.66454e-15 -9.65894e-15 -1.52656e-16 +104 1 0 0.839798 2.51939 -1.15463e-14 2.9976e-15 3.88578e-16 +105 1 1.6796 0 1.6796 2.15106e-16 -9.76996e-15 0 +106 1 2.51939 0.839798 1.6796 -1.71391e-15 2.66454e-15 3.88578e-16 +107 1 2.51939 0 2.51939 -1.74166e-15 -1.06581e-14 -1.60982e-15 +108 1 1.6796 0.839798 2.51939 2.63678e-16 3.10862e-15 -1.67227e-15 +109 1 3.35919 0 1.6796 1.42039e-14 -8.88178e-15 8.88178e-16 +110 1 4.19899 0.839798 1.6796 -2.18159e-14 2.44249e-15 -6.10623e-16 +111 1 4.19899 0 2.51939 -2.31759e-14 -9.76996e-15 -1.66533e-15 +112 1 3.35919 0.839798 2.51939 1.4419e-14 2.88658e-15 -1.90126e-15 +113 1 5.03879 0 1.6796 9.08995e-16 -9.76996e-15 8.88178e-16 +114 1 5.87859 0.839798 1.6796 2.02685e-14 2.44249e-15 1.02696e-15 +115 1 5.87859 0 2.51939 2.0213e-14 -8.88178e-15 -1.27676e-15 +116 1 5.03879 0.839798 2.51939 2.91434e-16 3.10862e-15 -1.45023e-15 +117 1 6.71838 0 1.6796 -2.30371e-15 -9.65894e-15 -9.02056e-17 +118 1 7.55818 0.839798 1.6796 3.747e-16 2.16493e-15 1.04083e-16 +119 1 7.55818 0 2.51939 1.33227e-15 -9.76996e-15 -1.9984e-15 +120 1 6.71838 0.839798 2.51939 -3.10862e-15 2.90046e-15 -2.10942e-15 +121 1 0 1.6796 1.6796 -1.28786e-14 8.88178e-16 6.66134e-16 +122 1 0.839798 2.51939 1.6796 2.33147e-15 -1.43635e-15 1.11022e-16 +123 1 0.839798 1.6796 2.51939 2.66454e-15 7.35523e-16 -1.30451e-15 +124 1 0 2.51939 2.51939 -9.76996e-15 -1.249e-15 -1.4988e-15 +125 1 1.6796 1.6796 1.6796 2.22045e-16 -1.67921e-15 5.96745e-16 +126 1 2.51939 2.51939 1.6796 -8.95117e-16 -2.39392e-15 -1.3739e-15 +127 1 2.51939 1.6796 2.51939 -9.22873e-16 1.38778e-17 -1.17267e-15 +128 1 1.6796 2.51939 2.51939 1.38778e-16 -1.4988e-15 -2.498e-15 +129 1 3.35919 1.6796 1.6796 1.44329e-14 -1.58207e-15 5.27356e-16 +130 1 4.19899 2.51939 1.6796 -2.17534e-14 -1.89432e-15 -4.85723e-16 +131 1 4.19899 1.6796 2.51939 -2.2024e-14 4.64906e-16 -2.11636e-15 +132 1 3.35919 2.51939 2.51939 1.47937e-14 -1.55431e-15 -2.52576e-15 +133 1 5.03879 1.6796 1.6796 6.38378e-16 -4.78784e-16 8.46545e-16 +134 1 5.87859 2.51939 1.6796 2.05322e-14 -1.4086e-15 2.28983e-16 +135 1 5.87859 1.6796 2.51939 2.02546e-14 -2.56739e-16 -2.07473e-15 +136 1 5.03879 2.51939 2.51939 5.82867e-16 -2.16493e-15 -2.498e-15 +137 1 6.71838 1.6796 1.6796 -2.16493e-15 -9.4369e-16 5.55112e-17 +138 1 7.55818 2.51939 1.6796 -4.44089e-16 -1.11022e-15 -2.77556e-17 +139 1 7.55818 1.6796 2.51939 4.44089e-16 -6.93889e-18 -2.22045e-15 +140 1 6.71838 2.51939 2.51939 -3.27516e-15 -1.76248e-15 -2.55351e-15 +141 1 0 3.35919 1.6796 -1.11022e-14 1.39888e-14 -2.22045e-16 +142 1 0.839798 4.19899 1.6796 2.55351e-15 -2.46053e-14 -7.77156e-16 +143 1 0.839798 3.35919 2.51939 2.88658e-15 1.46688e-14 -1.47105e-15 +144 1 0 4.19899 2.51939 -7.99361e-15 -2.26485e-14 -1.33227e-15 +145 1 1.6796 3.35919 1.6796 2.08167e-16 1.37251e-14 5.41234e-16 +146 1 2.51939 4.19899 1.6796 -1.9082e-15 -2.30926e-14 -1.55431e-15 +147 1 2.51939 3.35919 2.51939 -1.04777e-15 1.5099e-14 -1.77636e-15 +148 1 1.6796 4.19899 2.51939 -2.01228e-16 -2.22045e-14 -2.27596e-15 +149 1 3.35919 3.35919 1.6796 1.39194e-14 1.31006e-14 3.46945e-16 +150 1 4.19899 4.19899 1.6796 -2.1802e-14 -2.22045e-14 -4.44089e-16 +151 1 4.19899 3.35919 2.51939 -2.31759e-14 1.11022e-14 -2.44249e-15 +152 1 3.35919 4.19899 2.51939 1.19696e-14 -2.30926e-14 -1.38778e-15 +153 1 5.03879 3.35919 1.6796 -6.93889e-18 1.12688e-14 1.38778e-16 +154 1 5.87859 4.19899 1.6796 2.09208e-14 -2.22045e-14 -4.44089e-16 +155 1 5.87859 3.35919 2.51939 2.10595e-14 1.06581e-14 -1.9984e-15 +156 1 5.03879 4.19899 2.51939 -2.22045e-16 -2.13163e-14 -2.05391e-15 +157 1 6.71838 3.35919 1.6796 -2.96291e-15 1.29619e-14 -1.11716e-15 +158 1 7.55818 4.19899 1.6796 1.11022e-15 -2.30926e-14 -1.52656e-15 +159 1 7.55818 3.35919 2.51939 4.44089e-16 1.40998e-14 -8.88178e-16 +160 1 6.71838 4.19899 2.51939 -2.83107e-15 -2.29539e-14 -1.73472e-15 +161 1 0 5.03879 1.6796 -7.99361e-15 1.11022e-15 -4.44089e-16 +162 1 0.839798 5.87859 1.6796 2.44249e-15 1.9991e-14 2.77556e-16 +163 1 0.839798 5.03879 2.51939 2.88658e-15 6.80012e-16 -1.66533e-16 +164 1 0 5.87859 2.51939 -7.99361e-15 2.1011e-14 -1.77636e-15 +165 1 1.6796 5.03879 1.6796 4.71845e-16 -3.33067e-16 -1.11022e-16 +166 1 2.51939 5.87859 1.6796 -8.88178e-16 2.06501e-14 8.04912e-16 +167 1 2.51939 5.03879 2.51939 -2.06085e-15 -2.22045e-16 -1.08941e-15 +168 1 1.6796 5.87859 2.51939 2.63678e-16 2.05669e-14 -2.28983e-15 +169 1 3.35919 5.03879 1.6796 1.12202e-14 -1.11022e-15 6.93889e-16 +170 1 4.19899 5.87859 1.6796 -2.19824e-14 2.13163e-14 6.52256e-16 +171 1 4.19899 5.03879 2.51939 -1.94983e-14 -2.22045e-16 -1.7486e-15 +172 1 3.35919 5.87859 2.51939 1.26982e-14 2.15383e-14 -1.8735e-15 +173 1 5.03879 5.03879 1.6796 6.245e-17 -9.99201e-16 6.38378e-16 +174 1 5.87859 5.87859 1.6796 2.06501e-14 2.06501e-14 3.33067e-16 +175 1 5.87859 5.03879 2.51939 1.84575e-14 1.11022e-15 -8.04912e-16 +176 1 5.03879 5.87859 2.51939 -2.22045e-16 1.88322e-14 -2.51188e-15 +177 1 6.71838 5.03879 1.6796 -3.22659e-15 -1.26288e-15 -2.22045e-16 +178 1 7.55818 5.87859 1.6796 2.22045e-16 2.19824e-14 8.60423e-16 +179 1 7.55818 5.03879 2.51939 -8.88178e-16 1.11022e-16 -1.77636e-15 +180 1 6.71838 5.87859 2.51939 -2.9976e-15 2.17326e-14 -2.78944e-15 +181 1 0 6.71838 1.6796 -9.76996e-15 -2.88658e-15 0 +182 1 0.839798 7.55818 1.6796 2.10942e-15 1.17961e-15 9.15934e-16 +183 1 0.839798 6.71838 2.51939 2.66454e-15 -3.10862e-15 -1.19349e-15 +184 1 0 7.55818 2.51939 -1.06581e-14 8.88178e-16 -2.77556e-15 +185 1 1.6796 6.71838 1.6796 1.38778e-16 -2.31759e-15 -3.19189e-16 +186 1 2.51939 7.55818 1.6796 -1.1241e-15 8.8124e-16 -1.249e-16 +187 1 2.51939 6.71838 2.51939 -1.19349e-15 -3.10862e-15 -2.96985e-15 +188 1 1.6796 7.55818 2.51939 2.77556e-17 2.22045e-16 -1.9984e-15 +189 1 3.35919 6.71838 1.6796 1.29757e-14 -2.02616e-15 -5.06539e-16 +190 1 4.19899 7.55818 1.6796 -2.29122e-14 1.06859e-15 -2.91434e-16 +191 1 4.19899 6.71838 2.51939 -2.36616e-14 -4.60743e-15 -2.9976e-15 +192 1 3.35919 7.55818 2.51939 1.28508e-14 2.22045e-16 -2.22045e-15 +193 1 5.03879 6.71838 1.6796 1.31839e-16 -2.53964e-15 -6.52256e-16 +194 1 5.87859 7.55818 1.6796 2.15661e-14 7.63278e-16 -9.71445e-16 +195 1 5.87859 6.71838 2.51939 2.18089e-14 -3.88578e-15 -2.63678e-15 +196 1 5.03879 7.55818 2.51939 0 -6.66134e-16 -1.9984e-15 +197 1 6.71838 6.71838 1.6796 -2.24126e-15 -2.59515e-15 -1.0339e-15 +198 1 7.55818 7.55818 1.6796 4.44089e-16 0 -8.32667e-17 +199 1 7.55818 6.71838 2.51939 -8.88178e-16 -2.27596e-15 -1.77636e-15 +200 1 6.71838 7.55818 2.51939 -3.21965e-15 -9.71445e-17 -2.35922e-15 +201 1 0 0 3.35919 -1.06581e-14 -1.04361e-14 1.35447e-14 +202 1 0.839798 0.839798 3.35919 2.66454e-15 2.67841e-15 1.50435e-14 +203 1 0.839798 0 4.19899 2.88658e-15 -9.65894e-15 -2.24473e-14 +204 1 0 0.839798 4.19899 -7.99361e-15 2.88658e-15 -2.26485e-14 +205 1 1.6796 0 3.35919 2.15106e-16 -8.88178e-15 1.42109e-14 +206 1 2.51939 0.839798 3.35919 -1.83881e-15 2.77556e-15 1.55431e-14 +207 1 2.51939 0 4.19899 -1.76942e-15 -8.88178e-15 -2.35367e-14 +208 1 1.6796 0.839798 4.19899 -3.53884e-16 2.66454e-15 -2.19824e-14 +209 1 3.35919 0 3.35919 1.37598e-14 -7.99361e-15 1.46549e-14 +210 1 4.19899 0.839798 3.35919 -2.30232e-14 2.66454e-15 1.19071e-14 +211 1 4.19899 0 4.19899 -2.28637e-14 -7.10543e-15 -2.35367e-14 +212 1 3.35919 0.839798 4.19899 1.17892e-14 2.66454e-15 -2.28706e-14 +213 1 5.03879 0 3.35919 2.08167e-17 -7.99361e-15 1.08802e-14 +214 1 5.87859 0.839798 3.35919 2.2489e-14 2.55351e-15 1.36002e-14 +215 1 5.87859 0 4.19899 2.18922e-14 -5.32907e-15 -2.28706e-14 +216 1 5.03879 0.839798 4.19899 -1.25594e-15 2.66454e-15 -2.2024e-14 +217 1 6.71838 0 3.35919 -2.47025e-15 -8.77076e-15 1.29619e-14 +218 1 7.55818 0.839798 3.35919 -1.11022e-15 2.60902e-15 1.4766e-14 +219 1 7.55818 0 4.19899 -4.44089e-16 -6.66134e-15 -2.39808e-14 +220 1 6.71838 0.839798 4.19899 -2.60902e-15 2.90046e-15 -2.30371e-14 +221 1 0 1.6796 3.35919 -1.11022e-14 -2.22045e-16 1.44329e-14 +222 1 0.839798 2.51939 3.35919 2.77556e-15 -5.68989e-16 1.53766e-14 +223 1 0.839798 1.6796 4.19899 2.66454e-15 1.52656e-16 -2.39253e-14 +224 1 0 2.51939 4.19899 -8.88178e-15 -1.63758e-15 -2.37588e-14 +225 1 1.6796 1.6796 3.35919 2.22045e-16 -7.91034e-16 1.5779e-14 +226 1 2.51939 2.51939 3.35919 -1.4086e-15 -9.15934e-16 1.38917e-14 +227 1 2.51939 1.6796 4.19899 -1.72778e-15 2.84495e-16 -2.30926e-14 +228 1 1.6796 2.51939 4.19899 -7.28584e-16 -8.88178e-16 -2.2482e-14 +229 1 3.35919 1.6796 3.35919 1.39888e-14 -2.77556e-17 1.57235e-14 +230 1 4.19899 2.51939 3.35919 -2.32939e-14 -1.98452e-15 1.25663e-14 +231 1 4.19899 1.6796 4.19899 -2.16285e-14 -2.22045e-16 -2.22045e-14 +232 1 3.35919 2.51939 4.19899 1.21222e-14 -1.60982e-15 -2.33147e-14 +233 1 5.03879 1.6796 3.35919 -2.498e-16 -9.22873e-16 1.29757e-14 +234 1 5.87859 2.51939 3.35919 2.13649e-14 -9.71445e-17 1.28855e-14 +235 1 5.87859 1.6796 4.19899 2.10457e-14 -1.0339e-15 -2.22045e-14 +236 1 5.03879 2.51939 4.19899 -5.13478e-16 -2.05391e-15 -2.16771e-14 +237 1 6.71838 1.6796 3.35919 -3.19883e-15 -4.996e-16 1.39264e-14 +238 1 7.55818 2.51939 3.35919 -4.44089e-16 -2.22045e-15 1.29896e-14 +239 1 7.55818 1.6796 4.19899 6.66134e-16 -5.06539e-16 -2.4869e-14 +240 1 6.71838 2.51939 4.19899 -2.498e-15 -1.90126e-15 -2.40918e-14 +241 1 0 3.35919 3.35919 -1.11022e-14 1.35447e-14 1.33227e-14 +242 1 0.839798 4.19899 3.35919 2.77556e-15 -2.37171e-14 1.12133e-14 +243 1 0.839798 3.35919 4.19899 2.66454e-15 1.23929e-14 -2.45498e-14 +244 1 0 4.19899 4.19899 -7.10543e-15 -2.35367e-14 -2.29816e-14 +245 1 1.6796 3.35919 3.35919 2.08167e-16 1.33782e-14 1.51545e-14 +246 1 2.51939 4.19899 3.35919 -1.46411e-15 -2.13163e-14 1.06581e-14 +247 1 2.51939 3.35919 4.19899 -2.2829e-15 1.26565e-14 -2.33147e-14 +248 1 1.6796 4.19899 4.19899 -2.84495e-16 -2.30926e-14 -2.17604e-14 +249 1 3.35919 3.35919 3.35919 1.27814e-14 1.27121e-14 1.41553e-14 +250 1 4.19899 4.19899 3.35919 -2.30857e-14 -2.22045e-14 8.88178e-15 +251 1 4.19899 3.35919 4.19899 -2.29677e-14 9.32587e-15 -2.44249e-14 +252 1 3.35919 4.19899 4.19899 9.80466e-15 -2.30926e-14 -2.24265e-14 +253 1 5.03879 3.35919 3.35919 -2.28983e-16 1.00475e-14 1.12133e-14 +254 1 5.87859 4.19899 3.35919 2.19824e-14 -2.30926e-14 9.32587e-15 +255 1 5.87859 3.35919 4.19899 2.17881e-14 1.06581e-14 -2.53131e-14 +256 1 5.03879 4.19899 4.19899 -3.53884e-16 -2.04281e-14 -2.10942e-14 +257 1 6.71838 3.35919 3.35919 -3.1225e-15 1.29619e-14 1.27814e-14 +258 1 7.55818 4.19899 3.35919 6.66134e-16 -2.4647e-14 9.76996e-15 +259 1 7.55818 3.35919 4.19899 4.44089e-16 1.05749e-14 -2.53131e-14 +260 1 6.71838 4.19899 4.19899 -3.16414e-15 -2.29816e-14 -2.33424e-14 +261 1 0 5.03879 3.35919 -7.99361e-15 4.44089e-16 1.15463e-14 +262 1 0.839798 5.87859 3.35919 2.44249e-15 2.17673e-14 1.32672e-14 +263 1 0.839798 5.03879 4.19899 2.88658e-15 1.94289e-16 -2.1233e-14 +264 1 0 5.87859 4.19899 -6.21725e-15 2.16216e-14 -2.37588e-14 +265 1 1.6796 5.03879 3.35919 2.498e-16 -5.55112e-16 1.17684e-14 +266 1 2.51939 5.87859 3.35919 -1.11022e-15 2.13163e-14 1.34337e-14 +267 1 2.51939 5.03879 4.19899 -2.14412e-15 8.88178e-16 -2.12053e-14 +268 1 1.6796 5.87859 4.19899 2.498e-16 2.09971e-14 -2.13163e-14 +269 1 3.35919 5.03879 3.35919 1.09981e-14 -4.44089e-16 1.1241e-14 +270 1 4.19899 5.87859 3.35919 -2.33147e-14 2.19824e-14 1.00406e-14 +271 1 4.19899 5.03879 4.19899 -2.07542e-14 -4.44089e-16 -2.11775e-14 +272 1 3.35919 5.87859 4.19899 1.04916e-14 2.26069e-14 -2.22045e-14 +273 1 5.03879 5.03879 3.35919 6.245e-17 -3.33067e-16 8.27116e-15 +274 1 5.87859 5.87859 3.35919 2.19824e-14 2.10942e-14 9.47159e-15 +275 1 5.87859 5.03879 4.19899 1.91305e-14 4.44089e-16 -2.11775e-14 +276 1 5.03879 5.87859 4.19899 3.05311e-16 1.99285e-14 -2.13163e-14 +277 1 6.71838 5.03879 3.35919 -2.26208e-15 2.91434e-16 1.09773e-14 +278 1 7.55818 5.87859 3.35919 2.22045e-16 2.33147e-14 9.88098e-15 +279 1 7.55818 5.03879 4.19899 -4.44089e-16 5.55112e-16 -2.28706e-14 +280 1 6.71838 5.87859 4.19899 -3.10862e-15 2.27873e-14 -2.21212e-14 +281 1 0 6.71838 3.35919 -9.76996e-15 -3.77476e-15 1.31006e-14 +282 1 0.839798 7.55818 3.35919 2.22045e-15 3.46945e-16 1.46827e-14 +283 1 0.839798 6.71838 4.19899 2.66454e-15 -2.498e-15 -2.40086e-14 +284 1 0 7.55818 4.19899 -8.88178e-15 -2.22045e-16 -2.48135e-14 +285 1 1.6796 6.71838 3.35919 1.38778e-16 -2.25514e-15 1.30868e-14 +286 1 2.51939 7.55818 3.35919 -2.23432e-15 7.21645e-16 1.35447e-14 +287 1 2.51939 6.71838 4.19899 -1.64452e-15 -2.66454e-15 -2.40918e-14 +288 1 1.6796 7.55818 4.19899 -3.05311e-16 2.22045e-16 -2.39808e-14 +289 1 3.35919 6.71838 3.35919 1.25316e-14 -2.85189e-15 1.33574e-14 +290 1 4.19899 7.55818 3.35919 -2.53617e-14 -5.55112e-17 1.02141e-14 +291 1 4.19899 6.71838 4.19899 -2.41057e-14 -2.94209e-15 -2.32314e-14 +292 1 3.35919 7.55818 4.19899 1.14075e-14 2.22045e-16 -2.37588e-14 +293 1 5.03879 6.71838 3.35919 -3.1225e-16 -3.36536e-15 9.20097e-15 +294 1 5.87859 7.55818 3.35919 2.31273e-14 1.11022e-16 1.01585e-14 +295 1 5.87859 6.71838 4.19899 2.2711e-14 -3.4972e-15 -2.40918e-14 +296 1 5.03879 7.55818 4.19899 -8.32667e-17 6.66134e-16 -2.24265e-14 +297 1 6.71838 6.71838 3.35919 -3.13638e-15 -2.97679e-15 1.16573e-14 +298 1 7.55818 7.55818 3.35919 -4.44089e-16 -4.44089e-16 1.2268e-14 +299 1 7.55818 6.71838 4.19899 -4.44089e-16 -3.16414e-15 -2.62013e-14 +300 1 6.71838 7.55818 4.19899 -1.9984e-15 -1.52656e-16 -2.6118e-14 +301 1 0 0 5.03879 -7.99361e-15 -6.66134e-15 2.22045e-16 +302 1 0.839798 0.839798 5.03879 2.33147e-15 2.45637e-15 1.11022e-16 +303 1 0.839798 0 5.87859 2.44249e-15 -6.10623e-15 2.20934e-14 +304 1 0 0.839798 5.87859 -7.99361e-15 2.35922e-15 2.17604e-14 +305 1 1.6796 0 5.03879 -3.33067e-16 -8.88178e-15 0 +306 1 2.51939 0.839798 5.03879 -1.30451e-15 2.44249e-15 1.16573e-15 +307 1 2.51939 0 5.87859 -1.73472e-15 -7.10543e-15 2.13163e-14 +308 1 1.6796 0.839798 5.87859 2.77556e-17 3.33067e-15 2.08791e-14 +309 1 3.35919 0 5.03879 1.10051e-14 -7.99361e-15 6.66134e-16 +310 1 4.19899 0.839798 5.03879 -2.01922e-14 2.55351e-15 3.33067e-16 +311 1 4.19899 0 5.87859 -2.36061e-14 -4.44089e-15 2.226e-14 +312 1 3.35919 0.839798 5.87859 1.25663e-14 2.88658e-15 2.29261e-14 +313 1 5.03879 0 5.03879 -2.63678e-16 -6.21725e-15 1.11022e-15 +314 1 5.87859 0.839798 5.03879 1.90889e-14 2.66454e-15 1.22125e-15 +315 1 5.87859 0 5.87859 2.1913e-14 -4.44089e-15 2.19269e-14 +316 1 5.03879 0.839798 5.87859 -2.28983e-16 3.10862e-15 2.01297e-14 +317 1 6.71838 0 5.03879 -3.21965e-15 -4.38538e-15 7.49401e-16 +318 1 7.55818 0.839798 5.03879 -4.44089e-16 2.19269e-15 2.44249e-15 +319 1 7.55818 0 5.87859 -4.44089e-16 -7.32747e-15 2.37588e-14 +320 1 6.71838 0.839798 5.87859 -2.55351e-15 2.67841e-15 2.34257e-14 +321 1 0 1.6796 5.03879 -7.10543e-15 -6.66134e-16 8.88178e-16 +322 1 0.839798 2.51939 5.03879 2.44249e-15 -1.19349e-15 -2.77556e-17 +323 1 0.839798 1.6796 5.87859 2.66454e-15 -7.07767e-16 2.14273e-14 +324 1 0 2.51939 5.87859 -7.99361e-15 -1.66533e-15 2.14828e-14 +325 1 1.6796 1.6796 5.03879 1.94289e-16 -5.48173e-16 4.44089e-16 +326 1 2.51939 2.51939 5.03879 -1.02696e-15 -1.26288e-15 -7.56339e-16 +327 1 2.51939 1.6796 5.87859 -8.88178e-16 9.71445e-17 2.10942e-14 +328 1 1.6796 2.51939 5.87859 1.38778e-17 -6.10623e-16 2.04003e-14 +329 1 3.35919 1.6796 5.03879 1.18031e-14 2.42861e-16 -2.22045e-16 +330 1 4.19899 2.51939 5.03879 -2.02546e-14 -2.13024e-15 3.53884e-16 +331 1 4.19899 1.6796 5.87859 -2.17604e-14 -1.80411e-16 2.13163e-14 +332 1 3.35919 2.51939 5.87859 1.22541e-14 -7.21645e-16 2.11497e-14 +333 1 5.03879 1.6796 5.03879 8.95117e-16 -5.75928e-16 8.88178e-16 +334 1 5.87859 2.51939 5.03879 1.87558e-14 -8.04912e-16 1.24206e-15 +335 1 5.87859 1.6796 5.87859 2.08722e-14 -3.46945e-16 2.10942e-14 +336 1 5.03879 2.51939 5.87859 1.20737e-15 -3.88578e-16 1.87628e-14 +337 1 6.71838 1.6796 5.03879 -3.00454e-15 -8.95117e-16 -4.16334e-17 +338 1 7.55818 2.51939 5.03879 -8.88178e-16 -1.77636e-15 9.4369e-16 +339 1 7.55818 1.6796 5.87859 2.22045e-16 9.4369e-16 2.22045e-14 +340 1 6.71838 2.51939 5.87859 -2.94209e-15 -1.17961e-15 2.15106e-14 +341 1 0 3.35919 5.03879 -7.99361e-15 1.06581e-14 0 +342 1 0.839798 4.19899 5.03879 2.66454e-15 -2.28359e-14 -1.38778e-16 +343 1 0.839798 3.35919 5.87859 2.44249e-15 1.19904e-14 2.33008e-14 +344 1 0 4.19899 5.87859 -6.21725e-15 -2.33147e-14 2.226e-14 +345 1 1.6796 3.35919 5.03879 2.08167e-16 1.11577e-14 4.996e-16 +346 1 2.51939 4.19899 5.03879 -1.74166e-15 -2.13163e-14 -4.44089e-16 +347 1 2.51939 3.35919 5.87859 -1.19349e-15 1.15463e-14 2.17604e-14 +348 1 1.6796 4.19899 5.87859 -5.55112e-17 -2.04281e-14 2.13718e-14 +349 1 3.35919 3.35919 5.03879 1.08177e-14 1.04916e-14 -2.77556e-16 +350 1 4.19899 4.19899 5.03879 -2.10457e-14 -2.13163e-14 -1.9984e-15 +351 1 4.19899 3.35919 5.87859 -2.33286e-14 9.76996e-15 2.15383e-14 +352 1 3.35919 4.19899 5.87859 1.03251e-14 -2.13163e-14 2.30926e-14 +353 1 5.03879 3.35919 5.03879 6.38378e-16 6.71685e-15 -1.66533e-16 +354 1 5.87859 4.19899 5.03879 1.88877e-14 -2.13163e-14 -4.44089e-16 +355 1 5.87859 3.35919 5.87859 2.20379e-14 9.99201e-15 2.24265e-14 +356 1 5.03879 4.19899 5.87859 9.71445e-17 -1.95399e-14 2.00395e-14 +357 1 6.71838 3.35919 5.03879 -2.92821e-15 9.64506e-15 -1.42941e-15 +358 1 7.55818 4.19899 5.03879 -2.22045e-16 -2.26485e-14 8.88178e-16 +359 1 7.55818 3.35919 5.87859 0 1.21014e-14 2.33147e-14 +360 1 6.71838 4.19899 5.87859 -3.4972e-15 -2.11775e-14 2.40086e-14 +361 1 0 5.03879 5.03879 -4.44089e-15 1.11022e-15 4.44089e-16 +362 1 0.839798 5.87859 5.03879 2.10942e-15 1.80897e-14 3.33067e-16 +363 1 0.839798 5.03879 5.87859 2.88658e-15 1.38778e-17 1.93734e-14 +364 1 0 5.87859 5.87859 -5.32907e-15 2.22322e-14 2.29261e-14 +365 1 1.6796 5.03879 5.03879 -2.08167e-16 -3.33067e-16 -4.996e-16 +366 1 2.51939 5.87859 5.03879 -1.56819e-15 1.85754e-14 2.44249e-15 +367 1 2.51939 5.03879 5.87859 -1.56819e-15 2.22045e-16 2.07334e-14 +368 1 1.6796 5.87859 5.87859 3.46945e-16 2.06085e-14 2.06155e-14 +369 1 3.35919 5.03879 5.03879 8.10463e-15 -2.22045e-16 6.66134e-16 +370 1 4.19899 5.87859 5.03879 -2.05252e-14 1.93803e-14 8.88178e-16 +371 1 4.19899 5.03879 5.87859 -2.11428e-14 1.11022e-15 1.98105e-14 +372 1 3.35919 5.87859 5.87859 1.05194e-14 2.16355e-14 2.19477e-14 +373 1 5.03879 5.03879 5.03879 -1.38778e-17 0 2.77556e-17 +374 1 5.87859 5.87859 5.03879 1.91513e-14 1.84922e-14 1.77636e-15 +375 1 5.87859 5.03879 5.87859 1.93248e-14 8.88178e-16 1.91375e-14 +376 1 5.03879 5.87859 5.87859 3.46945e-16 1.88322e-14 1.95607e-14 +377 1 6.71838 5.03879 5.03879 -3.06699e-15 6.93889e-17 -4.57967e-16 +378 1 7.55818 5.87859 5.03879 0 2.04281e-14 -4.44089e-16 +379 1 7.55818 5.03879 5.87859 4.44089e-16 5.82867e-16 2.19824e-14 +380 1 6.71838 5.87859 5.87859 -3.55271e-15 2.33841e-14 2.40086e-14 +381 1 0 6.71838 5.03879 -7.54952e-15 -4.44089e-15 8.88178e-16 +382 1 0.839798 7.55818 5.03879 2.33147e-15 -4.85723e-16 2.41474e-15 +383 1 0.839798 6.71838 5.87859 3.10862e-15 -1.33227e-15 2.21906e-14 +384 1 0 7.55818 5.87859 -6.21725e-15 0 2.35922e-14 +385 1 1.6796 6.71838 5.03879 6.45317e-16 -3.44863e-15 -2.63678e-16 +386 1 2.51939 7.55818 5.03879 -1.96371e-15 -5.55112e-17 5.55112e-16 +387 1 2.51939 6.71838 5.87859 -1.55431e-15 -1.66533e-15 2.21767e-14 +388 1 1.6796 7.55818 5.87859 3.46945e-16 6.66134e-16 2.19824e-14 +389 1 3.35919 6.71838 5.03879 1.04777e-14 -3.17107e-15 8.46545e-16 +390 1 4.19899 7.55818 5.03879 -2.16979e-14 1.66533e-16 2.10942e-15 +391 1 4.19899 6.71838 5.87859 -2.39531e-14 -2.88658e-15 2.22045e-14 +392 1 3.35919 7.55818 5.87859 1.07414e-14 2.22045e-16 2.33147e-14 +393 1 5.03879 6.71838 5.03879 3.67761e-16 -3.74006e-15 4.02456e-16 +394 1 5.87859 7.55818 5.03879 2.08999e-14 2.77556e-16 2.22045e-16 +395 1 5.87859 6.71838 5.87859 2.30649e-14 -1.94289e-15 2.37588e-14 +396 1 5.03879 7.55818 5.87859 1.38778e-16 2.22045e-16 2.13163e-14 +397 1 6.71838 6.71838 5.03879 -3.53884e-15 -3.51802e-15 -8.32667e-17 +398 1 7.55818 7.55818 5.03879 0 0 3.33067e-16 +399 1 7.55818 6.71838 5.87859 0 -3.55271e-15 2.44249e-14 +400 1 6.71838 7.55818 5.87859 -3.44169e-15 9.99201e-16 2.4647e-14 +401 1 0 0 6.71838 -9.76996e-15 -9.54792e-15 -3.77476e-15 +402 1 0.839798 0.839798 6.71838 2.66454e-15 2.67841e-15 -2.72005e-15 +403 1 0.839798 0 7.55818 2.55351e-15 -7.92422e-15 -7.21645e-16 +404 1 0 0.839798 7.55818 -7.99361e-15 2.56739e-15 -4.44089e-16 +405 1 1.6796 0 6.71838 2.498e-16 -8.88178e-15 -3.55271e-15 +406 1 2.51939 0.839798 6.71838 -1.8735e-15 2.77556e-15 -3.60822e-15 +407 1 2.51939 0 7.55818 -2.30371e-15 -7.10543e-15 6.66134e-16 +408 1 1.6796 0.839798 7.55818 1.16573e-15 2.55351e-15 3.33067e-16 +409 1 3.35919 0 6.71838 1.26704e-14 -7.10543e-15 -3.10862e-15 +410 1 4.19899 0.839798 6.71838 -2.40641e-14 2.44249e-15 -4.69069e-15 +411 1 4.19899 0 7.55818 -2.46123e-14 -7.10543e-15 -6.66134e-16 +412 1 3.35919 0.839798 7.55818 1.24484e-14 2.55351e-15 1.33227e-15 +413 1 5.03879 0 6.71838 2.63678e-16 -6.21725e-15 -3.9968e-15 +414 1 5.87859 0.839798 6.71838 2.22253e-14 2.55351e-15 -2.38698e-15 +415 1 5.87859 0 7.55818 2.26069e-14 -6.21725e-15 -6.66134e-16 +416 1 5.03879 0.839798 7.55818 -1.66533e-16 2.77556e-15 1.66533e-16 +417 1 6.71838 0 6.71838 -2.498e-15 -6.99441e-15 -4.16334e-15 +418 1 7.55818 0.839798 6.71838 -1.16573e-15 2.60902e-15 -3.10862e-15 +419 1 7.55818 0 7.55818 -4.44089e-16 -8.65974e-15 -8.88178e-16 +420 1 6.71838 0.839798 7.55818 -3.16414e-15 2.45637e-15 6.66134e-16 +421 1 0 1.6796 6.71838 -9.32587e-15 -4.44089e-16 -3.33067e-15 +422 1 0.839798 2.51939 6.71838 2.9976e-15 -1.49186e-15 -3.69149e-15 +423 1 0.839798 1.6796 7.55818 2.55351e-15 7.49401e-16 8.88178e-16 +424 1 0 2.51939 7.55818 -8.88178e-15 -2.28983e-15 8.88178e-16 +425 1 1.6796 1.6796 6.71838 2.08167e-16 -7.63278e-16 -3.20577e-15 +426 1 2.51939 2.51939 6.71838 -1.38778e-15 -1.06165e-15 -4.37844e-15 +427 1 2.51939 1.6796 7.55818 -1.4988e-15 3.33067e-16 -3.26128e-16 +428 1 1.6796 2.51939 7.55818 1.38778e-16 -1.4988e-15 3.05311e-16 +429 1 3.35919 1.6796 6.71838 1.30312e-14 -8.95117e-16 -3.41394e-15 +430 1 4.19899 2.51939 6.71838 -2.33355e-14 -1.58901e-15 -5.10703e-15 +431 1 4.19899 1.6796 7.55818 -2.35506e-14 -4.23273e-16 3.46945e-17 +432 1 3.35919 2.51939 7.55818 1.32186e-14 -1.16573e-15 8.04912e-16 +433 1 5.03879 1.6796 6.71838 0 -5.68989e-16 -2.42861e-15 +434 1 5.87859 2.51939 6.71838 2.25098e-14 -1.25594e-15 -3.50414e-15 +435 1 5.87859 1.6796 7.55818 2.22322e-14 -6.93889e-17 2.28983e-16 +436 1 5.03879 2.51939 7.55818 3.60822e-16 -1.60982e-15 1.11022e-15 +437 1 6.71838 1.6796 6.71838 -3.21271e-15 -5.06539e-16 -3.48332e-15 +438 1 7.55818 2.51939 6.71838 -2.22045e-16 -1.77636e-15 -3.44169e-15 +439 1 7.55818 1.6796 7.55818 8.88178e-16 2.08167e-16 4.44089e-16 +440 1 6.71838 2.51939 7.55818 -2.60902e-15 -9.85323e-16 -2.498e-16 +441 1 0 3.35919 6.71838 -1.02141e-14 1.33227e-14 -3.33067e-15 +442 1 0.839798 4.19899 6.71838 2.77556e-15 -2.37171e-14 -3.94129e-15 +443 1 0.839798 3.35919 7.55818 2.55351e-15 1.37113e-14 1.94289e-15 +444 1 0 4.19899 7.55818 -7.99361e-15 -2.4647e-14 -6.66134e-16 +445 1 1.6796 3.35919 6.71838 2.22045e-16 1.2601e-14 -1.94289e-15 +446 1 2.51939 4.19899 6.71838 -1.70697e-15 -2.30926e-14 -4.66294e-15 +447 1 2.51939 3.35919 7.55818 -1.94289e-15 1.33227e-14 1.77636e-15 +448 1 1.6796 4.19899 7.55818 -6.38378e-16 -2.30926e-14 1.9984e-15 +449 1 3.35919 3.35919 6.71838 1.28439e-14 1.19904e-14 -2.05391e-15 +450 1 4.19899 4.19899 6.71838 -2.41265e-14 -2.22045e-14 -3.55271e-15 +451 1 4.19899 3.35919 7.55818 -2.48274e-14 1.02141e-14 8.88178e-16 +452 1 3.35919 4.19899 7.55818 1.20182e-14 -2.30926e-14 2.22045e-16 +453 1 5.03879 3.35919 6.71838 -2.35922e-16 9.49241e-15 -1.9984e-15 +454 1 5.87859 4.19899 6.71838 2.29608e-14 -2.39808e-14 -4.66294e-15 +455 1 5.87859 3.35919 7.55818 2.30649e-14 1.15463e-14 1.33227e-15 +456 1 5.03879 4.19899 7.55818 2.77556e-17 -2.30926e-14 1.55431e-15 +457 1 6.71838 3.35919 6.71838 -3.13638e-15 1.16851e-14 -2.09555e-15 +458 1 7.55818 4.19899 6.71838 -2.22045e-16 -2.5091e-14 -2.10942e-15 +459 1 7.55818 3.35919 7.55818 -8.88178e-16 1.28231e-14 4.44089e-16 +460 1 6.71838 4.19899 7.55818 -3.4972e-15 -2.54935e-14 9.99201e-16 +461 1 0 5.03879 6.71838 -7.10543e-15 8.88178e-16 -3.9968e-15 +462 1 0.839798 5.87859 6.71838 2.66454e-15 2.20796e-14 -3.27516e-15 +463 1 0.839798 5.03879 7.55818 3.10862e-15 4.02456e-16 -5.55112e-16 +464 1 0 5.87859 7.55818 -5.32907e-15 2.28151e-14 -2.22045e-16 +465 1 1.6796 5.03879 6.71838 4.44089e-16 -5.55112e-16 -2.63678e-15 +466 1 2.51939 5.87859 6.71838 -1.33227e-15 2.24265e-14 -3.08087e-15 +467 1 2.51939 5.03879 7.55818 -2.13024e-15 3.33067e-16 -3.88578e-16 +468 1 1.6796 5.87859 7.55818 4.57967e-16 2.30371e-14 4.51028e-16 +469 1 3.35919 5.03879 6.71838 1.02279e-14 -1.11022e-16 -2.58127e-15 +470 1 4.19899 5.87859 6.71838 -2.37588e-14 2.30926e-14 -3.37924e-15 +471 1 4.19899 5.03879 7.55818 -2.2489e-14 -2.22045e-16 -3.33067e-16 +472 1 3.35919 5.87859 7.55818 1.17684e-14 2.40502e-14 9.4369e-16 +473 1 5.03879 5.03879 6.71838 2.15106e-16 2.22045e-16 -2.83107e-15 +474 1 5.87859 5.87859 6.71838 2.28706e-14 2.26485e-14 -3.66374e-15 +475 1 5.87859 5.03879 7.55818 2.09346e-14 -3.33067e-16 -1.94289e-16 +476 1 5.03879 5.87859 7.55818 2.35922e-16 2.18159e-14 8.39606e-16 +477 1 6.71838 5.03879 6.71838 -3.3723e-15 -2.63678e-16 -2.04003e-15 +478 1 7.55818 5.87859 6.71838 -2.22045e-16 2.44249e-14 -4.27436e-15 +479 1 7.55818 5.03879 7.55818 -8.88178e-16 1.249e-16 -2.22045e-16 +480 1 6.71838 5.87859 7.55818 -3.55271e-15 2.49384e-14 -2.22045e-16 +481 1 0 6.71838 6.71838 -8.88178e-15 -3.9968e-15 -2.88658e-15 +482 1 0.839798 7.55818 6.71838 2.33147e-15 -2.77556e-16 -2.94209e-15 +483 1 0.839798 6.71838 7.55818 2.77556e-15 -2.8727e-15 -3.88578e-16 +484 1 0 7.55818 7.55818 -9.76996e-15 -4.44089e-16 -6.66134e-16 +485 1 1.6796 6.71838 6.71838 2.15106e-16 -3.93435e-15 -3.94129e-15 +486 1 2.51939 7.55818 6.71838 -2.44249e-15 -1.66533e-16 -3.60822e-15 +487 1 2.51939 6.71838 7.55818 -1.249e-15 -2.83107e-15 -7.21645e-16 +488 1 1.6796 7.55818 7.55818 0 4.44089e-16 8.88178e-16 +489 1 3.35919 6.71838 6.71838 1.22749e-14 -3.60129e-15 -4.05231e-15 +490 1 4.19899 7.55818 6.71838 -2.59862e-14 2.22045e-16 -3.27516e-15 +491 1 4.19899 6.71838 7.55818 -2.56323e-14 -3.9968e-15 -9.99201e-16 +492 1 3.35919 7.55818 7.55818 1.15741e-14 6.66134e-16 0 +493 1 5.03879 6.71838 6.71838 0 -3.25434e-15 -4.08007e-15 +494 1 5.87859 7.55818 6.71838 2.46539e-14 6.66134e-16 -2.66454e-15 +495 1 5.87859 6.71838 7.55818 2.4189e-14 -3.44169e-15 -2.22045e-16 +496 1 5.03879 7.55818 7.55818 0 2.22045e-16 4.44089e-16 +497 1 6.71838 6.71838 6.71838 -2.58127e-15 -4.07313e-15 -3.92741e-15 +498 1 7.55818 7.55818 6.71838 -2.22045e-16 0 -3.05311e-15 +499 1 7.55818 6.71838 7.55818 0 -2.72005e-15 -1.33227e-15 +500 1 6.71838 7.55818 7.55818 -3.9968e-15 2.35922e-16 -2.22045e-16 +ITEM: TIMESTEP +100 +ITEM: NUMBER OF ATOMS +500 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +ITEM: ATOMS id type x y z f_2[1] f_2[2] f_2[3] +1 1 0.123071 8.38872 8.3161 -13.5034 12.7208 4.27264 +2 1 0.832093 0.789482 0.0260634 11.6405 -9.02308 5.27054 +3 1 0.829348 8.32295 0.847054 0.253685 2.42198 0.190462 +4 1 0.167866 0.883683 1.1203 3.78838 -17.5987 -23.5446 +5 1 1.84325 0.268983 0.0506746 -34.1939 -23.1747 -16.5239 +6 1 2.48966 1.02521 0.0150167 17.3336 21.4777 -8.17686 +7 1 2.69085 0.133161 0.584204 54.6376 -37.2919 -8.47938 +8 1 2.03129 0.673907 1.00581 -42.9604 37.8091 32.6152 +9 1 3.4644 0.135395 8.22513 6.66121 1.25052 1.24977 +10 1 4.03955 1.11148 8.14659 12.0412 -8.97859 6.48992 +11 1 4.19379 0.0448744 0.829139 -7.8302 -27.8417 -6.76025 +12 1 3.64841 0.913699 0.700293 -19.72 -1.80986 -1.25088 +13 1 4.95468 8.24864 0.0754237 1.84477 -0.530278 -6.08608 +14 1 5.56087 0.715896 7.89459 8.56765 -1.46102 11.0915 +15 1 5.88623 0.0411411 0.556827 1.26181 -8.5789 -11.0866 +16 1 4.92937 0.724638 0.812217 17.273 10.8714 -8.85433 +17 1 6.72739 8.38085 8.13417 -35.3805 -5.9515 28.6252 +18 1 7.72548 0.788736 0.0488514 2.00593 -21.6326 -29.6842 +19 1 7.72508 8.25409 0.930095 1.50566 4.42937 -3.62071 +20 1 6.80396 0.557293 0.840198 23.1381 -17.3706 0.134541 +21 1 0.229449 1.60533 8.39298 -14.4977 16.7962 1.07689 +22 1 0.832071 2.6454 0.0244343 3.40253 -11.2938 10.3532 +23 1 1.17502 1.54184 1.17348 -25.8959 -2.9461 -24.9151 +24 1 0.259004 2.30396 1.08005 -0.921709 -4.92947 -4.61717 +25 1 1.52612 1.69846 0.0790119 2.24081 -1.66091 4.11232 +26 1 2.32335 2.59169 0.0356063 -1.33192 -7.27448 11.4357 +27 1 2.47613 1.68798 0.866847 -6.11708 -1.09078 12.1273 +28 1 1.75964 2.46963 1.02161 -10.4242 6.62214 -9.26339 +29 1 3.18899 1.91192 0.152422 12.8306 -10.0239 -26.2805 +30 1 4.16606 2.56561 0.31819 6.19268 17.1047 -29.5908 +31 1 4.20679 1.77492 0.904599 6.39419 -20.2587 16.143 +32 1 3.29457 2.54016 0.942536 8.4707 7.62624 9.38928 +33 1 5.08962 1.70142 0.228194 -1.96985 -10.7878 -18.1781 +34 1 5.8401 2.50153 8.17919 2.2116 -4.35098 8.5453 +35 1 6.13077 1.14332 0.361455 -13.4767 12.4455 -5.6398 +36 1 5.21187 2.29543 1.04708 -21.2445 17.0192 -2.44157 +37 1 7.1904 2.12537 8.11861 -26.262 1.63538 -8.89421 +38 1 7.82272 2.3769 0.452291 6.46918 9.92036 10.2415 +39 1 7.65568 1.36632 0.837818 -8.61574 34.9087 15.0511 +40 1 6.63096 2.29607 0.833592 -3.02945 -9.31899 -38.2195 +41 1 0.0701224 3.26957 0.347776 -7.76983 -4.00147 -12.0182 +42 1 0.634247 4.2146 8.13102 5.69069 28.6823 19.9973 +43 1 0.89062 3.25892 1.01274 -8.90571 5.17288 9.1951 +44 1 8.35578 4.21333 0.756755 0.0651816 10.3427 6.16366 +45 1 1.59376 3.50824 0.337522 12.8481 -18.5931 -31.178 +46 1 2.63362 4.08805 -0.0117409 -13.6881 -31.4545 31.8377 +47 1 2.64545 3.44217 0.972182 1.32962 4.76915 -6.91838 +48 1 1.77157 4.31331 0.893182 6.24463 15.8362 30.2465 +49 1 3.30506 3.15734 -0.00281637 -4.50664 8.90697 10.0795 +50 1 4.20121 3.98351 8.24532 14.9588 -4.89636 4.16185 +51 1 4.14049 3.34001 1.03567 7.31744 -35.2634 -0.734077 +52 1 3.55633 4.09497 0.714486 -22.5487 2.59697 3.44603 +53 1 5.00488 3.2958 8.40544 4.72004 -3.7586 -0.0676635 +54 1 6.02419 4.38739 8.28472 2.63675 -3.85348 -7.36203 +55 1 5.82125 3.13701 0.812331 3.285 1.60137 -0.83853 +56 1 4.81191 4.1205 0.886429 26.0514 -19.7571 -10.6482 +57 1 6.37904 3.38462 8.29958 8.77859 5.40588 1.21659 +58 1 7.16155 4.27433 8.23885 -4.15514 -15.8519 20.8515 +59 1 7.46381 3.5222 0.62725 -6.50801 1.62892 11.1525 +60 1 6.52496 4.16064 0.796816 7.21171 -6.93074 -7.48151 +61 1 8.21062 5.02405 8.32529 2.06274 -1.43255 -7.09188 +62 1 0.856242 5.68027 8.15143 -7.33544 -9.25849 21.6195 +63 1 0.668812 5.05722 1.0253 10.4106 -11.6037 -16.0599 +64 1 0.100757 5.9519 0.987463 -8.02818 6.7945 -7.41084 +65 1 1.67634 4.74298 8.35528 -7.26839 1.52359 -11.0387 +66 1 2.38848 5.51086 0.107164 2.54651 6.03927 1.46743 +67 1 2.70757 4.93813 1.01132 -4.75577 -9.71554 1.13089 +68 1 1.3925 5.83052 0.707681 -1.14437 -6.44566 7.34655 +69 1 3.45574 4.66587 8.23291 4.73605 39.4767 5.5614 +70 1 4.43743 5.80479 0.164115 -6.64024 0.386075 1.78009 +71 1 4.2065 4.90669 0.741814 -23.5797 23.1046 -22.8102 +72 1 3.32112 5.74269 0.715517 7.3169 4.77905 3.84994 +73 1 5.16076 4.9557 8.31038 -10.6163 5.08193 1.86037 +74 1 5.94307 5.96922 0.174598 0.307423 -9.87615 -0.075099 +75 1 5.67998 4.99641 0.866467 -3.37502 0.387608 -1.06988 +76 1 5.10533 6.15466 0.974945 -0.684733 -17.9465 -18.2172 +77 1 6.66954 5.212 0.215572 3.55269 -19.7927 -9.30717 +78 1 7.63194 6.03007 0.0625005 22.452 -11.4487 -13.3981 +79 1 7.77987 5.15692 0.880268 -13.4303 3.64316 1.97115 +80 1 6.9443 6.00859 0.774386 -22.1564 -21.0173 44.3085 +81 1 0.211543 6.60981 0.114883 -6.22763 -3.96979 4.85396 +82 1 0.828363 7.71074 8.05758 6.57912 -12.175 1.18202 +83 1 0.8511 6.85772 1.00145 14.3344 -16.9148 6.86093 +84 1 0.108182 7.491 0.729711 -16.3275 13.3125 -2.16192 +85 1 1.32651 6.53754 8.31267 17.3977 32.295 0.779922 +86 1 2.45313 7.32438 0.161863 4.38219 8.94585 -15.0057 +87 1 2.22206 6.5101 0.817864 2.61276 2.64125 -0.96007 +88 1 1.71157 7.54558 0.836721 -10.8648 3.37169 8.49449 +89 1 3.33137 6.74361 0.251121 4.01956 -5.07144 -3.19134 +90 1 4.31785 7.3164 0.250439 -2.62105 14.0423 -19.3334 +91 1 4.11403 6.69271 1.01148 -3.23605 5.58393 9.21791 +92 1 3.25046 7.65301 0.863299 7.69366 -3.67127 3.31805 +93 1 5.15822 6.61638 8.39412 -15.5898 18.5262 -4.77657 +94 1 5.88176 7.47131 8.35911 1.25772 40.9097 -41.218 +95 1 5.8589 6.89406 0.716878 17.4729 -36.9167 60.1945 +96 1 5.1317 7.5805 0.887324 -15.4398 8.72154 0.622041 +97 1 6.7242 6.72984 0.126171 2.95649 13.978 -28.6002 +98 1 7.71076 7.70275 8.27387 -25.252 1.96163 47.723 +99 1 7.67756 6.66145 0.969756 13.165 19.6736 4.48693 +100 1 6.86126 7.61056 0.694229 -2.98636 3.99324 3.02821 +101 1 8.36607 8.27958 1.86716 -0.17632 -3.19355 -10.789 +102 1 0.956051 0.693329 1.82901 -1.1092 0.489919 9.03263 +103 1 0.677954 8.19357 2.69404 9.64796 -1.44576 4.92708 +104 1 8.40822 0.658358 2.57043 0.358989 35.1247 -30.1625 +105 1 1.59709 8.27384 1.6579 -3.48424 8.95256 3.83776 +106 1 2.60262 0.937274 1.91114 -6.85695 -44.4167 -8.16487 +107 1 2.77964 8.33738 2.42411 -9.97653 17.8509 12.2111 +108 1 1.80103 0.545423 2.70436 3.05773 -0.374817 -3.43865 +109 1 3.48439 0.0645578 1.59153 -12.2456 1.16104 1.511 +110 1 4.22306 0.908637 1.62246 8.21176 3.032 -1.28199 +111 1 4.10829 0.251535 2.42791 -11.6297 -7.60593 -5.50766 +112 1 3.3006 0.854758 2.76304 -19.992 -17.3193 -31.4497 +113 1 4.89013 8.37666 1.691 47.9119 57.0599 0.585594 +114 1 5.94061 0.477826 1.48406 -3.07899 1.88699 12.3275 +115 1 5.88048 0.35971 2.56281 -4.35157 -20.3865 4.17854 +116 1 4.9283 1.00358 2.55425 0.721177 -5.70224 -8.52683 +117 1 6.83323 8.16485 1.66012 -9.63203 10.6138 -6.53177 +118 1 7.60236 0.72315 1.6205 1.19764 -13.0731 15.2148 +119 1 7.46261 8.34785 2.50942 4.27014 7.86644 3.21827 +120 1 6.98477 1.01167 2.43863 -2.7077 -3.72405 10.5475 +121 1 0.201795 1.49879 1.91201 12.0746 15.4759 7.55997 +122 1 0.970651 2.5763 1.77546 9.10281 -9.21672 19.206 +123 1 1.00278 1.70354 2.64935 -4.86832 -2.32063 -12.0578 +124 1 0.220174 2.4694 2.59226 -6.06395 2.41662 -4.31274 +125 1 1.87438 1.66139 1.85364 0.0891009 8.26815 7.54904 +126 1 2.5634 2.61259 1.66324 -1.39613 -9.56029 15.7565 +127 1 2.67373 1.74855 2.48368 16.2507 26.3662 25.5413 +128 1 1.81271 2.51993 2.48462 -12.4635 -12.9481 6.24626 +129 1 3.34642 1.5174 1.55361 6.72778 19.0825 -4.097 +130 1 4.08393 2.3973 1.7811 -4.91883 6.9472 -7.45962 +131 1 3.95017 1.57032 2.47783 9.96822 8.42852 -4.63348 +132 1 3.54843 2.54548 2.73936 0.891724 -11.4891 -8.75214 +133 1 5.35058 1.38537 1.51823 -3.50731 -2.89085 5.66595 +134 1 6.023 2.29204 1.65213 -4.43652 -0.464129 22.1024 +135 1 5.94747 1.35093 2.39209 2.54676 22.9646 2.61125 +136 1 4.92685 2.18916 2.37644 10.4243 -2.12633 1.01963 +137 1 6.61187 1.36453 1.49274 0.221959 8.29598 -0.620687 +138 1 7.32473 2.28685 1.57865 28.4734 -28.9459 -8.73783 +139 1 7.72873 1.81047 2.35176 -1.00775 -9.06934 31.0045 +140 1 6.61584 2.21437 2.52479 7.01251 0.0677084 2.80218 +141 1 8.39022 3.27891 1.73012 3.49525 -5.17929 -4.65996 +142 1 0.854964 4.19407 1.69788 1.56946 -2.00702 1.06174 +143 1 0.997978 3.23715 2.67504 2.30643 5.8223 1.06858 +144 1 7.97382 3.9138 2.48815 10.0732 9.91828 -12.5132 +145 1 1.83784 3.47408 1.69517 -12.404 -3.21409 -2.66267 +146 1 2.61842 4.21682 1.90008 2.14748 0.059531 -3.785 +147 1 2.48603 3.26502 2.5249 16.8304 14.9965 0.171158 +148 1 1.68761 4.23907 2.52806 -1.01396 -4.72261 -0.795752 +149 1 3.40602 3.2813 1.85914 -16.1626 0.355927 -8.83409 +150 1 4.09906 4.10307 1.70079 5.35563 8.08157 -4.08084 +151 1 4.20252 3.30769 2.50236 16.5461 8.94662 0.427258 +152 1 3.52577 4.20363 2.52362 -12.9682 0.481811 23.6133 +153 1 5.11847 3.18122 1.75203 -10.5302 -5.4337 -0.263304 +154 1 5.84661 3.9209 1.56262 -0.517958 8.86577 8.63788 +155 1 5.86922 3.05768 2.56393 3.07392 -0.105811 -3.05554 +156 1 4.80787 4.20147 2.51562 -15.5306 -18.6016 6.98719 +157 1 6.75594 3.06184 1.51831 -23.9843 53.9056 5.35996 +158 1 7.37411 4.33015 1.50837 10.7935 -8.89263 2.38858 +159 1 7.49772 2.90887 2.46868 -6.63254 10.1343 -14.9923 +160 1 6.70853 3.86113 2.32478 1.28299 1.19192 -0.76331 +161 1 8.35107 4.97447 1.76826 -6.01727 -4.60108 12.0065 +162 1 0.812206 5.83167 1.72433 7.83055 6.4827 17.8655 +163 1 0.780537 4.91988 2.60048 6.34607 -5.57446 -13.8552 +164 1 8.22728 5.818 2.44166 16.0462 -1.57715 15.6299 +165 1 1.69572 5.11642 1.80574 -4.96566 -14.135 -5.31489 +166 1 2.43043 5.85297 1.63568 5.29915 -1.62077 5.85546 +167 1 2.57792 5.02783 2.65315 -4.52746 -19.2236 -8.91777 +168 1 1.53526 5.79854 2.60003 3.8059 -10.2938 -9.84612 +169 1 3.51815 5.02648 1.76532 -11.6984 -21.692 -35.1665 +170 1 4.20879 5.78771 1.44267 -4.45704 -9.43328 11.2812 +171 1 4.17986 5.08228 2.52246 26.037 -4.72131 -0.0794421 +172 1 3.28564 5.71935 2.4374 15.7539 34.931 2.27384 +173 1 4.77269 4.90482 1.56605 20.4715 8.53759 27.1606 +174 1 6.0822 5.98003 1.39493 -10.1112 -7.66907 2.17662 +175 1 5.55864 4.81486 2.32198 32.4427 -4.71792 -40.0608 +176 1 5.42317 5.8389 2.32907 -1.32862 11.7729 0.869635 +177 1 6.58632 5.00994 1.4228 1.50987 11.9718 7.91199 +178 1 7.40728 5.76017 1.85143 -17.7756 -1.69935 -20.7445 +179 1 7.43483 4.90248 2.50406 4.81208 -4.17509 -3.00519 +180 1 6.49032 6.25339 2.53785 -9.86939 -13.1275 -11.226 +181 1 8.38687 6.70803 1.84686 8.51598 2.67685 -7.76441 +182 1 0.82672 7.5809 1.8586 -8.65199 -8.55201 -6.88257 +183 1 0.798368 6.66179 2.58415 -9.89719 -0.151349 -9.60426 +184 1 8.09266 7.50342 2.71078 14.8523 -0.33865 -5.72558 +185 1 1.67226 6.92941 1.90638 3.68667 -6.81729 -3.8166 +186 1 2.44977 7.72472 1.67328 13.6121 -19.3583 -10.8323 +187 1 2.6005 7.00136 2.53195 -4.75836 -8.709 1.95523 +188 1 1.74762 7.69197 2.71318 -2.53247 4.05033 -0.19863 +189 1 3.12318 6.68472 1.56494 -10.4586 3.85751 -11.4518 +190 1 4.29009 7.65387 1.60791 -51.7416 -54.1223 -14.9832 +191 1 3.94907 6.70085 2.16915 18.0446 -8.10905 7.08373 +192 1 3.47208 7.58339 2.49347 14.5465 5.92984 -2.02778 +193 1 5.12563 6.77282 1.76131 -9.48863 14.4825 6.97263 +194 1 5.83539 7.62987 1.64588 8.72191 3.82062 7.16953 +195 1 5.76423 6.96836 2.55864 -5.64345 11.6948 11.2338 +196 1 4.77822 7.71547 2.51809 6.21883 -11.3323 9.13654 +197 1 6.63559 6.81418 1.65333 9.11964 14.1494 -8.37133 +198 1 7.61434 7.47455 1.72558 2.40335 0.461228 -6.0911 +199 1 7.4792 6.66861 2.39873 -2.80551 0.930229 8.6336 +200 1 6.74988 7.49855 2.51532 0.27108 -2.11137 5.23264 +201 1 8.33028 0.11458 3.36279 -16.5826 -29.3888 39.8482 +202 1 0.924222 0.663074 3.34599 -4.22349 8.71948 1.26084 +203 1 0.761543 8.18959 3.97906 2.12091 4.50677 4.24971 +204 1 8.33433 0.813163 4.20564 6.5007 1.52148 -0.192127 +205 1 1.76574 0.0375621 3.77071 17.3013 -16.3871 -16.9245 +206 1 2.61977 0.818953 3.52119 -23.2651 -2.55324 12.2346 +207 1 2.77562 0.0652161 4.44741 -11.8421 6.13727 -13.8855 +208 1 1.49199 0.761034 4.41597 -5.10709 15.0925 14.5126 +209 1 3.2179 8.34804 3.44668 5.27936 -7.50847 -1.90568 +210 1 3.9439 0.797129 3.52456 17.3728 2.18733 11.5361 +211 1 4.23279 0.116688 4.32559 -2.42219 -2.56552 -2.26636 +212 1 3.32804 0.997948 4.36883 1.65433 -5.54648 3.47818 +213 1 4.71275 0.120112 3.21294 23.362 4.56383 23.3458 +214 1 5.81093 1.04185 3.50642 -3.03834 -26.4106 -17.8435 +215 1 5.68877 0.288558 4.20831 -1.41276 -13.7346 9.5471 +216 1 5.01865 1.1392 4.32627 0.968145 -3.23051 -6.43149 +217 1 6.64793 8.39618 3.24984 2.09632 -4.36032 3.69009 +218 1 7.5883 0.965027 3.40354 -4.44096 -3.20185 -1.58139 +219 1 7.46506 8.38162 4.26807 1.21074 2.40143 -20.8016 +220 1 6.68567 0.729309 4.05423 9.00491 -0.0257829 7.04417 +221 1 0.0217051 1.65067 3.33296 -0.896942 -12.0422 -1.44038 +222 1 0.778955 2.33585 3.53158 8.17696 34.6193 -17.2054 +223 1 0.812105 1.63712 4.22741 2.15493 -21.1842 9.58449 +224 1 8.36402 2.71734 4.23224 9.90405 -0.180735 2.89262 +225 1 1.64503 1.55583 3.44456 9.91651 -2.24847 10.5707 +226 1 2.72789 2.60115 3.33289 -22.1633 -6.4618 14.3253 +227 1 2.53285 1.75288 4.15927 -11.2604 4.59027 8.59695 +228 1 1.59486 2.51559 4.29587 -0.634079 -19.903 20.3392 +229 1 3.26158 1.6458 3.43181 16.9482 17.4067 -1.31054 +230 1 4.49124 2.67296 3.29881 0.516577 8.93567 6.85853 +231 1 4.12441 1.76399 4.16025 -12.4119 -16.9863 20.8263 +232 1 3.58648 2.62356 4.12513 -11.0948 -0.0880381 2.09248 +233 1 4.62064 1.66433 3.30411 17.3359 -14.3916 -7.7698 +234 1 5.72203 2.02067 3.4449 -2.49843 31.6335 -13.0426 +235 1 6.15135 1.60495 4.33133 -9.75959 4.02084 8.19224 +236 1 5.04088 2.23941 4.27882 30.2001 -2.39587 -19.7025 +237 1 6.91779 1.8813 3.52264 3.96777 -26.054 4.41687 +238 1 7.81771 2.53776 3.353 -2.77684 -3.41763 12.6677 +239 1 7.78069 1.81171 4.34601 -52.3825 1.07947 -51.791 +240 1 6.66141 2.49312 4.62997 -6.69802 -0.0628228 -12.7191 +241 1 0.122629 3.46604 3.3479 -1.26446 -22.7991 -11.2332 +242 1 0.85888 4.22824 3.46647 2.79502 3.87933 -3.60293 +243 1 0.937247 3.40088 4.29114 -12.1658 -1.27655 -7.25993 +244 1 8.30307 4.19021 4.02192 -7.37977 10.0618 19.4199 +245 1 1.73804 3.18337 3.5685 -15.8464 9.26468 -37.1326 +246 1 2.58615 4.05913 3.19953 0.360202 14.7294 -1.16411 +247 1 2.55925 3.4674 4.05471 16.7959 -2.51521 13.6147 +248 1 1.75131 4.20697 4.04231 3.51698 -5.56503 7.27084 +249 1 3.44857 3.37138 3.44602 9.39764 18.3315 -14.5187 +250 1 4.30487 4.37452 3.51867 -0.743412 -11.0963 -4.3924 +251 1 4.41614 3.34547 4.13696 17.6233 7.57534 -14.2893 +252 1 3.32801 4.25542 4.08286 6.07649 -1.13934 3.22429 +253 1 5.63651 3.09553 3.631 -4.7187 3.44811 6.48572 +254 1 5.99275 4.08946 3.17209 -2.06613 -3.23888 -8.73239 +255 1 6.47603 3.67609 4.18744 -9.24013 0.891239 -0.0265923 +256 1 5.32989 4.17403 4.01248 -3.14576 -0.648453 6.26049 +257 1 6.72457 2.86539 3.51605 -3.69406 17.3565 -4.96963 +258 1 7.32281 3.76777 3.25105 -10.2265 -1.63605 18.2335 +259 1 7.4303 3.25631 4.3358 5.44768 7.87627 -9.74689 +260 1 6.66407 4.65396 3.76405 -6.96361 -4.18223 2.73914 +261 1 8.26711 4.8857 3.17584 6.51218 -0.295316 -2.27808 +262 1 0.649285 5.74933 3.20979 -12.9544 -9.12523 -13.313 +263 1 1.01858 5.10915 4.40565 1.04387 0.402418 -2.70019 +264 1 0.0855082 5.80312 4.16158 -11.0199 -7.09759 8.81305 +265 1 1.78399 4.97143 3.32025 -23.7199 7.54456 -3.60592 +266 1 2.55969 5.96317 3.12483 -8.84523 11.7944 16.8138 +267 1 2.653 5.05017 3.85074 -4.37713 4.79953 16.9312 +268 1 2.04667 5.9581 4.23583 -12.9689 -9.50066 -2.67062 +269 1 3.52568 5.09169 3.32195 -1.60301 -3.74832 -0.530875 +270 1 4.17719 5.92991 3.13207 5.79449 2.84869 4.98978 +271 1 4.69237 5.20087 4.04914 -22.9168 0.480558 19.5714 +272 1 3.49623 5.87284 4.08872 -22.1914 -19.7939 -11.835 +273 1 5.22134 4.9979 3.22696 -11.435 -2.89555 -13.2152 +274 1 5.65705 6.11892 3.42751 2.78011 1.11701 -3.25891 +275 1 5.76121 5.22134 4.03501 7.67556 -2.59727 25.3068 +276 1 4.95772 6.04539 4.58052 58.0203 8.0254 -45.1554 +277 1 6.4538 5.11955 2.78748 -4.74406 7.07146 5.73728 +278 1 7.21538 5.95413 3.16364 10.7768 -10.9442 6.36207 +279 1 7.51809 5.20099 3.85697 17.9797 5.14787 9.68311 +280 1 6.63903 5.76912 4.06379 2.12496 12.0521 4.75162 +281 1 8.12324 6.45888 3.3557 6.09728 0.195353 -8.64393 +282 1 0.462088 7.19726 3.46792 19.553 -0.0547515 -15.4409 +283 1 0.957118 6.33073 3.94731 10.4711 20.6934 10.8557 +284 1 8.31788 7.62476 4.18946 -15.5996 1.5203 27.0435 +285 1 1.621 6.60508 3.20723 21.3874 20.2704 9.57573 +286 1 2.43565 7.40381 3.575 -2.23423 10.7661 -7.60718 +287 1 2.75508 6.70843 4.26783 9.69215 -9.86312 8.63304 +288 1 1.4194 7.32943 4.0782 6.712 1.12768 -13.3449 +289 1 3.55435 6.77984 3.25216 -11.0849 -3.43265 4.44657 +290 1 4.09983 7.6717 3.40332 0.775894 2.91256 6.51607 +291 1 4.08342 6.6168 4.34423 8.99422 27.9061 4.38721 +292 1 3.36001 7.55781 4.25663 44.0502 4.81661 -43.4399 +293 1 4.74991 6.77738 3.51304 4.59094 -3.55683 -10.177 +294 1 5.77556 7.6737 3.71378 -0.245399 -1.3978 -0.93703 +295 1 5.90589 6.74801 4.34426 -3.316 -4.25196 -0.216303 +296 1 4.8074 7.40991 4.34207 4.23627 19.8452 -2.32284 +297 1 6.58813 6.85169 3.45364 -7.67639 -5.27403 -11.3349 +298 1 7.50241 7.47925 3.56723 2.18816 13.5038 -24.0989 +299 1 7.40344 6.62065 4.10638 -2.8935 -4.19323 5.51308 +300 1 6.75843 7.5046 4.25149 -20.47 8.43665 16.7865 +301 1 8.33167 8.36145 4.9892 0.225809 34.2346 -31.8957 +302 1 0.576342 0.867151 5.40959 24.5697 -12.6304 -33.2572 +303 1 0.763006 0.00458111 6.00676 12.4506 6.43147 -2.11226 +304 1 8.26499 0.860176 6.08382 -7.17683 -4.07129 -51.5552 +305 1 1.81244 8.0383 4.87052 -5.76863 7.26347 -9.86755 +306 1 2.53533 1.09902 5.19234 -3.16803 0.678291 -2.97003 +307 1 2.78135 0.403413 6.40689 -26.816 9.12488 -11.3363 +308 1 1.58905 0.651353 5.66283 7.03419 0.981612 1.76622 +309 1 3.32058 0.106866 5.32447 -0.932856 13.5857 14.9154 +310 1 4.27557 0.92435 5.10725 -6.99093 5.63655 -6.45098 +311 1 4.28959 0.280237 5.95961 -30.2191 -30.0316 -14.6333 +312 1 3.38904 1.26869 5.835 20.8336 -7.28254 -13.6106 +313 1 5.00946 8.32617 5.09801 -7.438 6.03549 0.926349 +314 1 5.92216 0.863628 5.14574 -0.277075 -6.34381 -3.05305 +315 1 5.73427 0.0193827 5.90902 4.17974 0.428592 2.11829 +316 1 4.94752 0.963499 5.95092 36.9682 12.4342 8.28196 +317 1 6.68007 0.0753806 5.17719 -6.21888 -0.275929 -7.94036 +318 1 7.59475 0.718477 4.99 5.56935 4.26124 12.8688 +319 1 7.48253 8.3166 5.84711 10.9136 10.2783 15.4989 +320 1 6.8326 0.897437 5.9487 8.18452 -13.9005 5.8213 +321 1 0.0760609 1.64664 4.96296 26.1716 -2.70613 34.3225 +322 1 0.685552 2.56455 5.03633 12.0035 4.84556 -15.2829 +323 1 0.606729 1.82267 5.82598 7.27963 -3.46786 12.0617 +324 1 8.3293 2.58271 5.72712 2.9601 13.0212 32.1025 +325 1 1.39999 1.70565 5.12122 8.3487 -4.09076 2.04128 +326 1 2.73507 2.85653 4.90403 -0.345779 -0.804973 -4.73226 +327 1 2.41817 2.24309 5.70209 1.42091 -4.90412 -0.964796 +328 1 1.38108 2.54746 5.86585 12.2906 4.17611 0.525771 +329 1 3.33731 1.91289 4.90293 0.0185627 0.794978 8.4213 +330 1 4.3973 2.60866 4.92615 -15.1153 4.67891 22.5372 +331 1 4.2225 2.0218 5.81106 18.0418 -47.4422 -19.4137 +332 1 3.4994 2.65878 5.66207 -24.6152 28.1329 2.91513 +333 1 5.20081 1.64695 5.25699 -1.61968 25.0354 -10.6249 +334 1 5.90254 2.56674 5.38347 4.70787 3.18361 -12.95 +335 1 6.08989 1.61464 5.89214 -10.9271 -1.55847 2.77666 +336 1 5.02754 2.69198 5.87273 -13.869 2.1523 1.52243 +337 1 6.90208 1.46146 5.07178 -10.118 15.4867 -8.4201 +338 1 7.58477 2.54489 5.07036 0.223295 2.60985 -3.71518 +339 1 7.69807 1.70404 5.74305 2.65747 -7.01835 5.70621 +340 1 6.83671 2.31874 5.77518 8.75763 5.85965 2.81961 +341 1 8.33535 3.4475 5.0472 4.04483 5.65066 -3.26522 +342 1 0.908217 4.16423 5.06292 -2.0575 1.13184 -0.501506 +343 1 0.771491 3.42595 5.87741 5.33449 1.31478 -10.6197 +344 1 0.14652 4.33584 6.04676 1.00462 -8.1578 -20.2597 +345 1 1.77294 3.51463 4.93957 -1.27898 -7.63546 3.32247 +346 1 2.71396 3.96357 4.97834 15.9141 3.79204 10.1307 +347 1 2.46159 3.38803 6.16546 -1.0491 -20.8555 -15.9327 +348 1 1.72608 4.39112 6.04032 -15.046 -11.018 -10.0045 +349 1 3.71274 3.40467 4.85974 -22.3519 13.9348 10.8973 +350 1 4.57553 4.21697 4.87404 -3.96399 7.00234 -1.98713 +351 1 4.366 3.53193 5.70269 7.89254 -3.17347 6.37497 +352 1 3.55123 4.20329 5.82208 -22.8323 -11.992 0.86056 +353 1 5.31479 3.43328 4.96004 -12.842 -18.3451 -4.95866 +354 1 5.96487 4.21664 4.98586 3.26728 12.2832 1.14917 +355 1 5.67633 3.58987 5.96581 6.91479 -13.8012 -0.0730494 +356 1 5.15168 4.48521 5.88819 -0.135174 -6.62981 7.61527 +357 1 6.76571 3.37692 5.24691 -14.8051 -2.47074 -4.50431 +358 1 7.42413 4.19524 5.01259 2.27671 4.46784 -0.576517 +359 1 7.6092 3.42318 5.84837 11.8264 -15.8262 -18.7291 +360 1 6.54398 4.29611 5.89957 10.509 -8.9195 -1.16059 +361 1 0.0247094 4.83566 4.99938 1.36656 0.603431 -2.15766 +362 1 0.966205 6.14847 4.9405 -1.84638 -2.56131 10.6129 +363 1 1.10739 5.11215 5.5368 -2.77114 7.32267 -6.17701 +364 1 0.221311 5.77966 5.62316 -16.3542 -5.99991 -34.5248 +365 1 2.09075 4.80339 4.88071 -15.5377 1.88455 -3.51044 +366 1 2.76626 5.59872 5.00497 -13.1053 -0.333159 -40.3797 +367 1 2.60002 4.95633 5.81939 -13.3057 -3.60712 -16.1699 +368 1 1.73302 6.11974 5.67311 7.80367 -13.5214 9.39307 +369 1 3.69174 5.11983 4.8182 4.27828 -13.6521 -3.16237 +370 1 4.24517 5.95869 5.19837 -53.2876 -10.1225 40.5156 +371 1 4.22774 4.94663 5.7496 8.19104 22.5118 -1.663 +372 1 3.1136 6.02947 5.80151 37.6339 -12.4217 36.265 +373 1 5.23537 5.12533 5.07481 2.14794 5.35663 -5.58383 +374 1 5.80775 6.19434 5.36474 -12.1517 -18.4331 -19.8184 +375 1 5.9697 5.18437 6.0003 -7.47906 6.99384 0.912527 +376 1 4.94854 5.8692 5.99559 17.5377 -1.26338 -12.9619 +377 1 6.59757 5.09144 5.08104 3.06742 4.08464 -2.92894 +378 1 7.54367 5.98613 4.88573 -14.2361 -23.7654 7.79426 +379 1 7.60847 5.23322 5.63185 -1.35187 -6.94343 4.2911 +380 1 6.70769 5.94816 5.81677 14.1283 2.13907 3.81564 +381 1 8.22278 6.71702 5.01662 22.4316 17.1972 -3.51396 +382 1 0.869349 7.28869 4.96667 -10.0366 3.62496 3.89926 +383 1 0.896793 6.73687 5.91431 -6.40765 3.74255 3.0528 +384 1 0.0890555 7.7054 5.6706 -5.18167 -47.9244 34.8448 +385 1 1.8751 6.88564 4.94229 0.477268 -2.00274 -5.71819 +386 1 2.7587 7.55291 4.99872 -36.0591 6.05211 43.0833 +387 1 2.53846 6.82983 5.7787 -13.9577 26.1772 12.6196 +388 1 1.63934 7.57104 5.79621 -1.51722 -4.07644 10.4552 +389 1 3.46612 6.83867 5.20388 -3.25728 -8.15264 -25.1259 +390 1 4.01792 7.77747 5.13143 8.22604 -9.98488 -11.0207 +391 1 4.0616 6.71165 5.99374 37.4635 -34.7522 2.57336 +392 1 3.49035 7.48383 6.06615 -52.3442 43.3465 -6.60384 +393 1 4.82693 6.8523 5.20763 2.69445 10.0085 20.3981 +394 1 5.83663 7.67662 4.94011 2.65651 0.782445 -0.458959 +395 1 5.60118 6.903 6.05259 0.51238 5.45548 -5.22943 +396 1 4.49984 7.67391 6.05154 31.0401 -0.647522 -9.371 +397 1 6.56806 6.92617 5.22736 4.49918 -20.7724 -24.6194 +398 1 7.45007 7.68748 5.02454 6.13987 -21.0163 7.77973 +399 1 7.49751 6.80367 5.78308 -9.98894 13.1501 -5.7166 +400 1 6.63057 7.61754 5.92417 0.0687578 21.3795 23.8905 +401 1 8.32557 8.34894 6.68981 0.104638 -13.8897 -9.6087 +402 1 0.744366 0.980723 6.48852 -5.23114 -31.7269 30.0044 +403 1 1.21108 0.262565 7.55604 -5.48851 -4.18087 -6.76609 +404 1 8.40118 0.701811 7.40569 17.4537 3.62996 11.6339 +405 1 1.79336 8.32699 6.64062 -5.93242 0.737609 -0.84307 +406 1 2.60519 1.4776 6.42908 -42.7477 -20.3947 10.8513 +407 1 2.68468 8.32969 7.50367 2.82039 -8.74718 0.911275 +408 1 2.14004 0.776947 7.26895 -3.65906 16.1309 -1.11008 +409 1 3.6569 0.0715803 6.70451 13.9675 -20.3473 29.1568 +410 1 3.94985 1.1248 6.78323 8.0083 0.919865 -1.94163 +411 1 4.44955 0.15543 7.5921 -15.5929 3.09145 7.2634 +412 1 3.18676 1.19789 7.55079 30.4701 -36.3009 -8.08868 +413 1 5.10396 0.131358 6.81912 -7.97923 37.9971 -21.1894 +414 1 5.81993 0.996314 6.79068 7.76858 -21.7284 -2.73997 +415 1 5.80025 8.18188 7.49322 12.3507 -13.1302 8.70784 +416 1 4.85408 1.28227 7.42764 -12.4579 -6.47968 -9.5274 +417 1 6.58875 0.130914 6.74241 2.12753 -2.2097 0.634037 +418 1 7.59964 0.676617 6.71682 -68.3673 2.07925 42.2066 +419 1 7.52212 0.0593286 7.5834 32.5631 3.04014 -28.8024 +420 1 6.85279 0.923554 7.57208 -4.28539 1.49265 -2.17621 +421 1 8.34941 1.72633 6.6429 -6.24486 10.7883 12.2426 +422 1 0.752277 2.47155 6.72526 -3.9412 -10.7788 3.00465 +423 1 0.813192 1.63555 7.42993 -7.74314 -11.2011 -0.638694 +424 1 8.22443 2.54813 7.66732 2.56273 -1.56785 0.82339 +425 1 1.49636 1.56107 6.38447 44.5625 33.4582 -3.13704 +426 1 2.30525 2.475 6.76961 -5.35408 6.54562 -0.949005 +427 1 2.49056 1.84724 7.59513 -61.407 9.30511 10.8314 +428 1 1.49273 2.39823 7.65033 13.5773 11.0727 -11.0854 +429 1 3.37689 2.03992 6.64219 17.5424 18.1797 1.52712 +430 1 4.36556 2.35363 6.72974 2.65202 20.8248 17.9478 +431 1 3.99822 2.02063 7.6547 18.3091 -10.0739 6.1027 +432 1 3.17328 2.55424 7.53823 -10.8617 31.8229 -4.73645 +433 1 5.21112 1.76508 6.50479 -18.4173 6.52495 3.64931 +434 1 5.87572 2.50861 6.47972 17.6588 16.4017 11.3405 +435 1 6.13161 1.75643 7.42519 -6.35346 6.11936 8.80778 +436 1 5.08243 2.27965 7.49559 3.10695 14.763 0.591819 +437 1 6.90515 1.73737 6.69685 6.36969 -4.89015 -2.67266 +438 1 7.59965 2.63279 6.71489 9.55617 -0.301288 -8.47778 +439 1 7.76189 1.52013 7.52701 3.93719 -1.66085 -6.19761 +440 1 6.70724 2.6779 7.2598 -8.99322 4.2321 11.9078 +441 1 0.125444 3.31521 6.66881 -20.5423 -11.9528 1.08126 +442 1 0.364694 4.22273 7.06 15.4688 8.78987 -5.27721 +443 1 0.60791 3.34758 7.65433 9.81501 -30.9601 -14.2913 +444 1 8.0984 3.85412 7.73406 0.295867 21.4592 0.238003 +445 1 1.38869 3.28611 6.86269 8.50148 8.2104 -0.813622 +446 1 2.52476 4.25334 6.66316 13.9982 13.4488 20.9739 +447 1 2.34408 3.26799 7.64808 -1.14502 9.26403 -10.1755 +448 1 1.45935 4.43411 7.31503 0.0272838 -0.538431 -2.52173 +449 1 3.66593 3.34626 6.65797 -1.50742 -4.19973 -15.7128 +450 1 4.32339 4.28741 6.63848 -1.71153 0.00989822 -0.270268 +451 1 4.03917 3.1404 7.61252 24.7136 -10.2891 3.12208 +452 1 3.36907 3.93473 7.50701 -10.481 -0.383957 -6.9951 +453 1 4.88527 3.3354 6.73465 -0.250758 1.18323 3.20962 +454 1 5.86197 4.30684 6.74144 -6.02175 10.4775 -12.9313 +455 1 5.83143 3.4729 7.33725 -5.24712 -23.3614 7.27214 +456 1 5.04517 4.19893 7.47372 14.0277 -13.7659 1.86079 +457 1 6.67093 3.19494 6.32389 -1.08882 16.2366 5.3564 +458 1 7.58567 3.93824 6.68879 13.8607 17.9546 17.9945 +459 1 7.41034 3.22296 8.01852 -22.7502 -28.7124 0.282368 +460 1 6.74041 3.98357 7.25541 -1.38378 3.03134 11.4432 +461 1 8.11164 5.05821 6.64701 -10.3621 4.23498 3.48281 +462 1 0.434229 5.95598 6.55583 13.6324 -1.56553 39.6492 +463 1 0.429061 5.17903 7.41995 -0.29478 -7.71855 -15.5486 +464 1 8.09598 5.94892 7.38464 -0.670206 -2.17368 6.38869 +465 1 1.41611 5.29567 6.55129 0.191903 6.07763 6.12613 +466 1 2.44376 5.87825 6.63669 -4.18767 0.226771 1.1996 +467 1 2.57445 4.71437 7.62895 -9.06207 26.6712 -23.195 +468 1 1.76163 5.67875 7.56712 4.16416 -0.382203 -1.94173 +469 1 3.23562 5.1121 6.55719 20.8924 -0.347412 22.4145 +470 1 4.05367 5.80831 6.49809 -13.6658 -13.8236 9.34588 +471 1 4.3499 4.91428 7.57309 -17.8958 19.2373 1.53594 +472 1 3.33848 5.81136 8.0112 0.629066 -2.48199 -2.55986 +473 1 5.22933 5.24678 6.83002 -9.21161 -10.3226 -4.65561 +474 1 5.87231 6.12998 6.73434 -14.492 -21.708 -7.10976 +475 1 6.102 5.06631 7.42095 8.16162 7.57706 8.09799 +476 1 5.11386 5.85851 7.69037 1.37823 -1.01778 -7.91082 +477 1 6.94866 5.10876 6.52261 -0.00645701 0.734687 4.76591 +478 1 7.67078 6.01392 6.41167 -4.02477 -14.728 2.57416 +479 1 7.35061 4.96205 7.5433 24.0095 -18.1944 -20.4412 +480 1 6.9284 5.83495 7.63045 -18.4707 37.5628 2.3937 +481 1 8.28984 6.85999 6.50497 12.0319 11.2505 5.01489 +482 1 0.775248 7.71516 6.80461 7.24585 -11.6558 8.08417 +483 1 0.533688 6.7762 7.54365 3.89137 -4.31915 -15.8578 +484 1 8.2465 7.61079 7.46416 25.9419 0.696332 -26.8887 +485 1 1.73177 6.71435 6.78434 -8.61422 -0.737705 -7.23833 +486 1 2.48272 7.50206 6.80041 12.0152 -3.31551 -7.82219 +487 1 2.37093 6.72113 7.64339 9.62293 -9.48685 2.94166 +488 1 1.77272 7.59226 7.58949 -2.97267 7.70343 0.621675 +489 1 3.29197 6.66554 6.74519 -6.55378 -4.76021 6.1499 +490 1 4.04728 7.44441 6.9325 9.38301 -4.09453 15.5296 +491 1 4.12674 6.55075 7.78018 3.09461 4.03017 -1.80654 +492 1 3.3807 7.43243 7.7243 -9.78058 -0.600287 9.7772 +493 1 4.74428 6.55735 6.78071 12.1641 10.0813 15.0085 +494 1 5.30209 7.56833 6.75011 8.90694 -20.2013 0.20059 +495 1 5.88783 6.83008 7.50111 -3.28565 3.55282 5.18781 +496 1 4.85536 7.429 7.66393 -0.8844 -0.824359 14.1315 +497 1 6.78323 6.58213 6.75112 16.4005 10.5566 0.00129152 +498 1 7.49771 7.53891 6.69245 -0.0692693 6.11315 -11.5276 +499 1 7.61589 6.80831 7.76686 -5.70997 -4.77696 -9.529 +500 1 6.80731 7.4637 7.45575 -10.489 5.43873 12.05 +ITEM: TIMESTEP +200 +ITEM: NUMBER OF ATOMS +500 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +ITEM: ATOMS id type x y z f_2[1] f_2[2] f_2[3] +1 1 8.41242 8.26599 8.38785 -10.0358 6.58437 5.2801 +2 1 0.814162 0.710931 0.0523899 -37.3452 31.5986 3.80166 +3 1 0.707188 8.3394 0.783901 7.22527 -6.84977 10.4166 +4 1 0.078844 0.75192 1.11978 38.2878 -8.01586 -1.83777 +5 1 1.52052 0.0613493 8.33894 50.642 -18.5757 54.2409 +6 1 2.63022 0.777198 -0.0136511 -14.6872 26.2087 -8.24369 +7 1 2.86573 8.3667 0.519039 4.98442 -20.5506 12.9041 +8 1 1.4757 0.711348 0.992341 22.4024 -8.05229 -33.8354 +9 1 3.79318 8.20698 8.14977 -12.6173 11.8638 7.05406 +10 1 4.0381 1.06879 8.36154 -11.3644 -3.77089 -31.1235 +11 1 3.94622 0.00241404 0.83531 3.0713 5.57971 3.39388 +12 1 3.2904 1.19609 0.697286 11.5663 -9.90219 11.4209 +13 1 4.80931 8.28217 0.152557 1.5084 -10.3853 -19.3359 +14 1 5.59181 0.724855 8.1093 -26.5323 12.4899 -7.60558 +15 1 5.68752 0.120676 0.713607 11.3113 1.42738 1.49966 +16 1 4.78554 0.81043 0.585131 26.0655 -22.1296 9.76004 +17 1 6.43613 0.237453 8.26775 30.1844 -14.2258 6.08634 +18 1 7.5043 0.643436 0.0691857 2.69659 0.617275 -0.831401 +19 1 7.7682 0.0476766 1.0238 2.88283 -8.74262 5.4154 +20 1 6.83111 0.459822 0.931748 -10.2254 10.6222 -23.4955 +21 1 0.00401405 1.51379 8.26626 1.73444 -9.97848 2.73777 +22 1 0.631563 2.29056 0.214422 2.30445 -4.73927 -16.4851 +23 1 0.869727 1.5347 0.919411 -20.3113 -10.6479 -1.82401 +24 1 -0.0840974 2.27001 1.15035 26.4165 13.702 -18.8298 +25 1 1.67911 1.38813 0.0883733 4.29152 4.16945 3.72554 +26 1 2.34463 2.397 8.3967 -0.661743 10.3894 16.138 +27 1 2.41792 1.69378 0.837891 -11.9994 8.17272 5.13712 +28 1 1.50784 2.3296 0.8821 15.8347 5.46342 -6.24169 +29 1 3.19181 1.77289 8.14083 -8.92279 -4.86777 22.8625 +30 1 4.12817 2.46218 8.33741 8.13153 -11.9637 0.536015 +31 1 4.26337 1.62555 0.809789 -13.061 44.2943 -8.13534 +32 1 3.42316 2.33556 0.802814 -4.29938 0.254861 -1.13643 +33 1 5.0669 1.62594 8.33933 -4.47953 5.08137 -8.2197 +34 1 5.91213 2.40952 0.124369 -13.9 -26.0969 3.99436 +35 1 6.23275 1.281 0.442008 -1.76602 1.09435 0.219677 +36 1 5.05785 2.29128 0.753897 1.63462 9.40663 2.64296 +37 1 6.76196 1.99075 8.08873 7.25593 -6.72787 12.2575 +38 1 7.89568 2.35083 0.217856 -14.3986 10.074 -11.1844 +39 1 7.7557 1.40697 0.992421 -28.0785 15.2332 -13.5573 +40 1 6.69672 2.20109 0.984157 0.465363 17.7913 -13.2761 +41 1 8.2159 3.42858 0.185567 12.3977 0.764361 -3.90376 +42 1 0.927092 4.2442 8.41258 -26.45 -26.3493 -4.33489 +43 1 0.729094 3.09987 0.813639 -4.58702 16.175 15.6607 +44 1 0.0788068 4.49033 1.02182 1.48174 1.40892 2.78463 +45 1 1.55842 3.1508 0.126599 -1.73889 6.5262 3.04002 +46 1 2.29185 4.09245 0.0493365 -0.242842 -5.39025 -0.756334 +47 1 2.41785 3.22623 0.89121 8.0106 -0.183268 -6.38994 +48 1 1.56843 4.03679 0.931375 1.76309 0.26565 -2.14494 +49 1 3.4359 3.23233 0.0225532 -4.36687 10.8322 6.25926 +50 1 4.25669 4.07361 0.0880133 2.8279 3.66932 -9.72921 +51 1 4.34048 3.08558 0.785495 -4.69141 6.70607 0.15029 +52 1 3.59299 3.90329 0.886528 -10.5717 12.5753 -2.99495 +53 1 5.13064 3.04982 8.22833 -0.225212 8.61676 17.0697 +54 1 5.81502 4.09178 8.38841 -21.2737 -2.05468 -24.8502 +55 1 5.97613 3.1773 0.894798 -5.61602 -19.9636 -19.3342 +56 1 5.09497 3.91821 0.747666 0.511602 -0.648627 8.1507 +57 1 6.51767 3.18724 8.3864 17.647 23.2966 -13.5196 +58 1 7.37164 4.03522 8.29689 -11.4262 -6.53116 -1.21962 +59 1 7.31211 3.24078 0.704535 -4.3132 -0.596821 4.84194 +60 1 6.56447 4.1734 0.602333 27.4745 -11.0091 36.7473 +61 1 8.15631 4.68203 0.075112 10.7012 -10.9934 -7.99724 +62 1 1.11663 5.88929 8.3609 -7.93077 -20.1145 9.26986 +63 1 0.996074 4.97243 1.21409 -6.72433 0.768332 -3.74364 +64 1 0.189403 5.66667 0.913187 -7.3538 -1.57168 -7.21317 +65 1 1.58163 4.94764 0.201022 19.1991 11.3216 -0.454803 +66 1 2.29237 5.73911 0.0748948 8.80602 19.0835 -4.47029 +67 1 2.49097 4.65203 0.981363 3.25616 8.72811 -9.97843 +68 1 1.87095 5.55306 0.995907 1.03553 19.7133 11.0025 +69 1 3.18407 5.012 0.131558 5.578 6.2636 9.58863 +70 1 4.09719 5.68255 0.132658 4.03261 5.63654 -2.85988 +71 1 4.12395 4.88832 0.852082 2.34539 -1.75572 -18.9743 +72 1 3.07234 5.70133 0.969327 -0.346407 5.49919 1.56796 +73 1 5.11274 5.00399 0.171908 -9.99815 3.39538 19.3609 +74 1 5.76656 5.80521 0.11529 9.4035 3.26414 21.2303 +75 1 6.01079 5.05469 0.873922 -27.3446 -31.3954 -10.6646 +76 1 4.89913 5.95208 0.960158 8.00863 4.38535 -8.86024 +77 1 6.75863 4.93475 8.31779 -18.6284 14.8779 13.2188 +78 1 7.8245 5.62001 8.34465 11.2383 14.3374 0.909184 +79 1 7.51856 5.31135 0.853265 4.91639 -9.6583 11.5193 +80 1 6.62461 5.81662 0.841147 8.94471 25.6435 -17.3923 +81 1 0.202013 6.46046 8.33455 0.0609498 5.25542 6.45446 +82 1 0.889578 7.53674 8.33221 1.62686 -1.40391 0.0530776 +83 1 0.953366 6.38848 0.908196 -1.46223 4.85455 -5.86941 +84 1 0.145952 7.39993 0.791819 5.48829 -5.75958 -9.51465 +85 1 1.67676 6.71324 8.36121 2.78795 2.25277 6.97945 +86 1 2.21164 7.54618 8.16806 16.5579 9.64776 9.50482 +87 1 2.40278 6.62803 0.856512 -0.674903 -8.3487 -4.56859 +88 1 1.53782 7.38975 0.90846 -3.10291 8.8481 -14.5459 +89 1 3.27325 6.398 0.0420856 1.14847 -3.14438 14.8868 +90 1 4.24204 7.28724 8.33928 2.62398 3.89094 44.6004 +91 1 4.04999 6.6211 0.862788 13.5756 -10.8829 -5.05866 +92 1 3.45704 7.41684 0.605416 -19.3758 10.5723 4.19592 +93 1 5.13383 6.59732 8.2884 -30.4967 14.0841 16.2852 +94 1 5.83566 7.60311 0.0824633 -14.5596 3.16754 7.91958 +95 1 5.71227 6.86684 0.81732 11.5827 -10.7391 -7.91805 +96 1 4.90381 7.61313 0.94797 9.27737 -4.87268 -6.49352 +97 1 6.72722 6.86314 0.253587 -5.2734 -0.113759 -0.620065 +98 1 7.41232 7.77996 0.331703 18.857 -4.07135 -25.363 +99 1 7.56998 6.39348 0.735875 7.28329 1.56003 -0.789213 +100 1 6.66601 7.84216 0.965777 -32.1881 -17.8038 12.8266 +101 1 0.166766 -0.00131261 1.94063 8.32296 1.94608 -3.28266 +102 1 0.934833 0.817938 1.81275 -21.8629 -14.287 17.2076 +103 1 1.00207 0.316008 2.82556 -21.807 -5.91521 -4.01431 +104 1 8.35945 0.74 2.72116 2.32177 4.37751 -0.902675 +105 1 1.48465 8.25372 1.60749 -1.18562 -7.12983 8.20441 +106 1 2.44318 0.774258 1.4766 5.48942 -2.99924 2.57908 +107 1 2.3069 8.18025 2.36522 1.41087 2.4731 2.95424 +108 1 1.85775 0.858752 2.6061 9.12182 6.5265 -4.79678 +109 1 3.23269 0.0488049 1.82801 0.784922 27.4455 -30.2613 +110 1 4.21175 0.99942 1.57195 -9.49462 -27.3711 22.4225 +111 1 4.21293 0.25409 2.38861 -7.75181 -9.25535 -4.23311 +112 1 3.32934 0.964581 2.65137 -6.01516 -9.0041 -1.19732 +113 1 4.9787 0.193499 1.50831 -4.98755 -8.3429 -3.28083 +114 1 6.09517 0.531101 1.76326 -28.5995 19.6806 -10.71 +115 1 5.85753 8.23852 2.51303 -1.20503 -8.99564 8.87124 +116 1 5.17785 0.685106 2.40543 -1.30449 11.3507 4.36005 +117 1 6.91213 8.37413 1.83271 8.62238 -24.2277 10.2354 +118 1 7.62368 0.758482 1.85178 16.0234 8.8439 -5.1341 +119 1 7.66132 8.34118 2.51601 5.03438 -8.87196 18.1761 +120 1 6.82917 0.875718 2.51872 -7.12717 1.70889 8.15245 +121 1 0.0949053 1.53257 1.83348 -15.8355 -28.5862 13.9628 +122 1 0.822415 2.21502 1.73119 16.0449 19.2167 -17.682 +123 1 0.864878 1.50475 2.57372 12.4143 -0.0682656 8.67505 +124 1 0.199844 2.34986 2.54349 -13.4424 7.82132 10.7389 +125 1 1.68463 1.52556 1.71378 7.71699 13.5023 1.83995 +126 1 2.69369 2.59616 1.91546 -20.6965 -6.26723 -3.29779 +127 1 2.60471 1.76603 2.62425 -5.19989 2.78858 2.334 +128 1 1.44056 2.43723 2.51936 11.6798 4.82752 9.65183 +129 1 3.43446 1.65477 1.84942 -9.01773 7.52097 -5.37653 +130 1 4.19061 2.39179 1.65045 11.7616 -7.21515 -2.54075 +131 1 4.26672 1.39737 2.67586 10.1937 6.39563 -7.12371 +132 1 3.53921 2.577 2.549 6.10272 -3.10086 8.1996 +133 1 5.17395 1.33784 1.40963 0.810412 -15.8822 3.29742 +134 1 5.74074 2.13809 1.54869 21.9361 25.9957 -3.59082 +135 1 5.9363 1.515 2.34901 -9.46258 -12.7333 10.9894 +136 1 4.95982 2.19781 2.39856 0.709797 0.431383 -4.3853 +137 1 6.78917 1.32128 1.47071 -5.63197 2.68115 20.8841 +138 1 7.62581 2.16504 1.87345 17.6788 -6.34038 -2.38007 +139 1 7.68847 1.62015 2.88771 -1.999 -29.1097 -18.0204 +140 1 6.72066 2.18015 2.22288 -25.5596 -3.13399 14.9826 +141 1 8.10556 3.24278 1.47587 8.10057 -1.81275 -31.7951 +142 1 0.698788 3.89936 1.58833 21.0059 -8.7854 2.84332 +143 1 0.726156 3.39424 2.59236 2.18368 -0.846434 0.375997 +144 1 8.21488 4.03893 2.09204 -9.31366 21.6556 21.1016 +145 1 1.61294 3.13444 1.56982 -6.75222 2.4564 11.7453 +146 1 2.47309 3.97186 1.76449 2.21347 -7.98753 7.5428 +147 1 2.67292 3.22702 2.95068 5.54423 5.59107 -13.8219 +148 1 1.72826 4.2557 2.53344 -3.42962 -20.862 21.8798 +149 1 3.48214 3.13902 1.56572 3.70104 11.9942 4.11222 +150 1 4.3885 3.8788 1.62665 2.95307 16.2819 -22.5535 +151 1 4.3065 3.38859 2.48531 -9.81397 -19.0665 24.4754 +152 1 3.47101 4.13314 2.35987 0.052847 -5.96917 4.43729 +153 1 5.11162 3.02695 1.57487 -2.09605 4.71156 2.60925 +154 1 6.05823 3.77666 1.6683 -0.0795953 27.02 22.5131 +155 1 5.89604 2.8633 2.33341 1.61726 0.0933652 1.12851 +156 1 5.29152 3.73349 2.43504 2.35223 15.5067 -10.4051 +157 1 6.82698 3.04592 1.66447 4.37333 2.796 -3.08497 +158 1 7.47158 4.33914 1.21316 -2.11938 -7.51647 -10.9268 +159 1 7.68828 3.1018 2.37066 -8.14673 6.79824 16.7729 +160 1 7.09384 4.0081 2.08909 -5.93874 -19.0069 4.73504 +161 1 8.1255 5.22391 1.77055 19.2122 -25.3413 6.96334 +162 1 0.62612 5.90176 1.99772 9.96713 -14.5554 -17.3464 +163 1 0.76801 4.79289 2.36504 -2.78355 1.48316 -1.85895 +164 1 8.18318 5.95034 2.62286 5.26633 -16.349 1.23379 +165 1 1.81648 4.94963 1.84319 1.29255 4.07737 -28.8924 +166 1 2.40619 6.07189 1.89723 9.11627 0.0929027 -31.5253 +167 1 2.58707 5.01704 2.50938 -14.4694 3.44726 -14.5204 +168 1 1.72272 5.71364 2.51972 -25.0056 3.38939 29.4203 +169 1 3.42498 4.85355 1.57173 -14.1697 1.2804 16.3608 +170 1 4.15303 5.79502 1.71807 -6.58651 -0.238746 -3.12281 +171 1 4.46167 4.86212 2.18786 -1.52672 -11.6836 -0.120829 +172 1 3.29589 5.94757 2.4039 5.86702 -13.0661 19.8541 +173 1 5.03295 4.96131 1.30642 14.6935 -5.33684 5.62219 +174 1 5.82775 5.80433 1.62537 -3.48018 5.04048 -3.36734 +175 1 5.79583 4.80394 2.11298 -5.34853 -5.63002 0.159279 +176 1 5.01708 6.04912 2.32216 17.4276 -29.4439 17.4564 +177 1 6.71539 5.10912 1.63093 10.3915 -7.52696 11.1074 +178 1 7.41693 5.91425 1.78268 -24.8131 17.7871 4.30264 +179 1 7.12646 4.86445 2.63426 13.6393 21.9613 3.08537 +180 1 6.42336 6.18201 2.43584 15.1603 10.9548 -7.96948 +181 1 8.23881 6.55347 1.60468 9.12903 0.565206 1.23333 +182 1 0.678624 7.37322 1.88745 -5.46988 3.49615 -25.4292 +183 1 0.794621 6.6529 2.67297 0.0873755 -1.33888 6.26964 +184 1 8.30959 7.39568 2.5723 10.9372 15.1486 20.2523 +185 1 1.53592 6.72715 1.69313 10.3025 -8.32698 21.6565 +186 1 2.52873 7.48993 1.45805 2.51224 9.72508 0.958573 +187 1 2.57516 6.97533 2.39376 0.331622 5.62636 7.11361 +188 1 1.48127 7.49186 2.513 25.359 1.87736 0.862705 +189 1 3.42472 6.67917 1.69715 -9.14691 10.5288 -4.39359 +190 1 4.07864 7.56162 1.54537 -20.7523 -1.21573 5.0956 +191 1 4.22077 6.65705 2.50099 -12.9989 13.269 2.80638 +192 1 3.32476 7.76609 2.51834 12.0821 -31.6775 22.1813 +193 1 5.18316 6.78911 1.6853 -16.2098 8.5059 -12.8052 +194 1 5.76367 7.66024 1.61411 8.21393 8.40414 -2.16429 +195 1 5.72928 6.97443 2.55641 -4.2085 8.68736 -3.41382 +196 1 4.81509 7.65411 2.27112 9.64741 4.31731 11.3389 +197 1 6.71673 6.6577 1.40921 -4.23135 13.1654 3.72162 +198 1 7.9523 7.57862 1.62003 -19.0505 2.7611 2.11499 +199 1 7.55182 6.74669 2.5625 -26.4699 -4.16644 -1.81267 +200 1 6.71006 7.32273 2.23599 -2.19037 10.3011 3.68982 +201 1 8.3209 8.25724 3.44082 -11.2006 13.9316 -31.0885 +202 1 1.1383 0.707726 3.88488 2.87074 16.2111 -29.5751 +203 1 0.710637 8.17953 4.00977 26.7141 2.01724 45.2521 +204 1 0.017483 0.84611 4.17688 -4.01486 -16.4278 3.15279 +205 1 1.83485 0.022043 3.36625 6.99225 9.16158 -10.2142 +206 1 2.5734 1.02544 3.4638 -2.67645 -0.861554 5.53773 +207 1 2.46831 8.35234 4.18841 -8.88118 2.57467 1.82808 +208 1 1.9704 0.882634 4.50547 -3.01692 -0.258051 -7.68015 +209 1 3.15194 0.11929 3.26603 1.99843 -0.203753 6.521 +210 1 4.16362 0.594977 3.39201 1.91533 3.30238 12.0146 +211 1 4.48096 8.3197 4.27248 -34.7907 27.9025 -6.28307 +212 1 3.49096 0.991035 4.39487 -18.0924 -11.2469 -3.89782 +213 1 5.15221 8.33246 3.40287 -4.49662 4.44033 -5.3065 +214 1 5.83668 0.780008 3.22544 8.18869 5.41063 4.37051 +215 1 5.71056 8.31473 4.3397 -0.683085 13.1798 -1.88784 +216 1 5.01734 0.796017 4.33297 -1.83196 10.7479 -11.7081 +217 1 6.55531 0.0226915 3.33292 8.64001 -7.40459 4.85944 +218 1 7.40254 0.734891 3.44283 9.92215 2.2266 -9.49047 +219 1 7.60175 8.41313 4.17692 -11.7492 9.12522 14.6015 +220 1 6.69717 0.884026 4.20434 -2.52907 -5.48675 3.38708 +221 1 0.266587 1.50956 3.42506 -7.49445 4.66836 1.70669 +222 1 0.834612 2.3929 3.4535 3.19311 14.9998 -2.79098 +223 1 0.966342 1.70753 4.27772 -2.38166 -3.63555 7.29451 +224 1 8.31528 2.54359 4.03878 16.7451 -1.36482 20.306 +225 1 1.65675 1.69619 3.39484 3.12529 -6.34044 -1.62009 +226 1 2.21998 2.62053 3.66497 -8.94713 -4.89956 5.05059 +227 1 2.70158 1.84855 4.22365 -4.21065 -7.00328 -1.279 +228 1 1.73069 2.39291 4.69998 -11.0397 -15.2385 -11.7518 +229 1 3.63597 1.81901 3.49635 -5.37102 -6.0004 0.428615 +230 1 4.5181 2.45307 3.50704 1.92291 5.38714 1.37796 +231 1 4.28022 1.61295 4.532 11.684 13.523 -0.759472 +232 1 3.49161 2.67545 4.21356 3.70186 4.50981 -2.53687 +233 1 5.05676 1.45985 3.45113 -18.7528 -7.6908 -2.02124 +234 1 5.59639 2.31007 3.23954 13.071 6.11501 -14.1907 +235 1 5.90515 1.58558 4.07201 2.34854 -1.44676 5.83562 +236 1 5.6448 2.61062 4.20904 5.92031 11.7583 11.4648 +237 1 6.60245 1.81532 3.22394 -0.344578 -17.0844 -10.2298 +238 1 7.7209 2.5366 3.23021 -13.9757 26.3091 7.5372 +239 1 7.59991 1.69339 4.17685 -3.31209 -2.6982 -2.62135 +240 1 6.7571 2.48096 3.97019 3.90879 12.298 15.8753 +241 1 8.32132 3.59836 3.32434 15.1974 -18.6025 -8.65377 +242 1 0.758776 4.28533 3.41911 8.12571 10.2206 -6.43372 +243 1 0.714283 3.43939 4.05789 10.8012 -17.4951 -4.32355 +244 1 8.37038 4.20103 4.16336 -19.0683 10.428 -9.16118 +245 1 1.7111 3.58985 3.37102 -4.50013 -9.39619 -9.22108 +246 1 2.7295 4.29586 3.34058 -27.7709 -28.5377 3.76594 +247 1 2.75779 3.49033 4.0215 3.07014 12.8072 -10.7423 +248 1 1.81597 4.04867 4.27403 8.34757 5.06165 3.43123 +249 1 3.63217 3.50284 3.43026 7.64322 -9.23013 -17.5251 +250 1 4.42979 4.3957 3.21235 -5.21891 -3.02116 0.669719 +251 1 4.46277 3.52681 4.13413 -5.3566 -4.51807 -16.5208 +252 1 3.52987 4.30614 4.06609 5.60483 14.7001 10.5939 +253 1 5.31574 3.44078 3.42467 1.48508 -5.70873 13.1076 +254 1 6.44336 4.14284 2.93215 -36.0911 1.99853 0.657603 +255 1 6.52296 3.60341 4.02819 -0.573509 -3.99567 -1.18998 +256 1 5.23388 4.48156 3.97453 6.55779 -4.33302 -0.590571 +257 1 6.75544 3.08581 2.98548 -20.753 -29.7898 -6.93237 +258 1 7.36113 3.83069 3.18965 17.3707 23.8596 11.1094 +259 1 7.68707 3.36428 4.36221 -8.90323 13.3285 -23.8114 +260 1 6.58157 4.70256 3.96292 -12.6487 -1.89838 -2.64764 +261 1 8.03895 4.72186 3.2072 7.03567 0.390199 -0.150374 +262 1 0.641986 5.57832 3.32415 -3.93783 9.97933 -29.9316 +263 1 0.748525 5.2954 4.26917 10.3198 11.1143 16.7142 +264 1 8.33552 6.07931 4.24855 1.05812 -13.5964 19.1647 +265 1 1.90145 4.96491 3.42288 -7.34814 1.12325 1.52157 +266 1 2.61408 5.80343 3.49254 4.58835 0.11833 -14.0758 +267 1 2.80014 5.15473 4.32615 -31.6367 11.9713 -55.3412 +268 1 1.9564 6.07585 4.27618 -9.91164 -20.8823 -47.0179 +269 1 3.37946 4.96765 3.07865 55.664 27.3093 14.9143 +270 1 4.23608 5.59453 2.88525 -18.9133 13.1689 8.33969 +271 1 4.44604 5.19737 4.14454 -7.57666 -13.265 -14.5347 +272 1 3.6416 5.84891 3.83409 2.65328 -4.22633 -4.19185 +273 1 5.15151 5.25659 3.1676 14.0924 -4.2121 3.02426 +274 1 5.82306 6.30397 3.36345 -4.54273 -6.47443 0.566248 +275 1 5.74908 5.5163 4.09569 25.3818 -3.33304 -26.8083 +276 1 4.83867 6.14359 3.79115 -4.65662 -0.583485 3.38738 +277 1 6.22614 5.32285 2.95137 -4.13422 -8.32687 15.6358 +278 1 7.32122 5.97196 3.33835 -0.00434101 -1.28454 -1.88403 +279 1 7.49659 5.17369 4.09183 8.55988 6.64783 3.63555 +280 1 6.75151 6.22479 4.25773 -16.211 -27.6787 -10.8075 +281 1 8.29215 6.64155 3.42114 5.59717 18.8581 -19.6047 +282 1 0.763473 7.56557 3.23404 -12.9198 -1.64007 -15.2341 +283 1 1.0031 6.68313 3.72439 -4.3972 -14.7662 15.3222 +284 1 8.23363 7.61771 4.35977 7.30279 -9.1197 2.90547 +285 1 1.95141 6.6466 3.21786 0.736159 0.439247 -2.07076 +286 1 2.6385 7.59536 3.37124 -4.27783 -4.21174 -0.733124 +287 1 3.13092 6.60025 4.41497 -19.4938 11.5887 -14.0245 +288 1 1.65818 7.53719 3.85187 -1.11019 -9.22082 13.1065 +289 1 3.27775 6.71474 3.27823 1.67015 1.07042 -3.65835 +290 1 4.1525 7.8844 3.3351 -7.70608 -2.7891 -4.06245 +291 1 3.98551 7.08252 4.24517 31.7093 2.51435 -5.83578 +292 1 3.40048 7.93533 4.31596 7.03572 3.0716 -3.37554 +293 1 4.94636 7.13355 3.35885 -28.0161 -11.5072 -5.66389 +294 1 5.84413 7.52046 3.45751 31.3517 19.8289 8.4284 +295 1 5.90459 6.85513 4.30093 -7.30307 7.57049 -1.80424 +296 1 5.01344 7.53745 4.4217 23.0153 -42.676 2.37557 +297 1 6.69892 6.88846 3.31402 6.29068 2.24472 -2.02408 +298 1 7.47533 7.68601 3.37673 -12.6934 -11.1052 -3.87233 +299 1 7.49921 6.86202 4.09322 12.1924 13.0141 4.3943 +300 1 6.67133 7.90635 4.38865 4.30856 -16.1011 -10.8357 +301 1 8.27296 0.0768914 5.12036 9.18301 -5.97843 0.553246 +302 1 0.892643 0.477473 4.83579 -15.0913 15.4009 20.7636 +303 1 0.772154 0.130661 5.99646 -1.43861 1.07866 -2.10387 +304 1 8.25515 0.935072 5.88754 -0.221723 -11.6722 -2.23691 +305 1 1.48963 8.06671 4.97048 16.9477 -1.8997 -3.71962 +306 1 2.57496 1.15847 5.28752 41.8653 -9.27812 4.61709 +307 1 2.98732 0.492219 6.35067 -4.54422 -4.60939 3.20868 +308 1 1.84275 0.524647 5.86961 -0.917224 0.841047 0.660751 +309 1 2.97903 0.200446 5.09803 7.97745 -0.922342 6.62523 +310 1 4.26317 0.578438 5.09777 -3.02519 11.3137 -4.68966 +311 1 4.18994 0.120263 6.02339 -4.93913 2.59189 23.6551 +312 1 3.50295 1.24619 5.79637 -4.00764 -7.55023 -4.67003 +313 1 5.12205 8.32679 5.40632 -5.25746 3.73248 -3.11501 +314 1 5.80677 0.859185 4.97868 15.281 -0.410171 8.11126 +315 1 6.05354 -0.0201647 5.97574 -7.51195 2.16668 5.49645 +316 1 5.29101 1.10125 5.89955 -0.302158 5.37706 -3.33259 +317 1 6.70998 0.244047 5.12411 -32.2188 -6.24411 4.81733 +318 1 7.52467 0.777062 4.96861 20.8677 24.3354 -3.82818 +319 1 7.29721 0.136872 5.99355 7.05953 -3.3845 7.97045 +320 1 6.54852 0.902142 6.09075 8.2259 10.3777 -12.9847 +321 1 8.3753 1.53724 4.98157 2.17311 8.15625 3.98817 +322 1 0.71432 2.51412 5.02068 -12.4966 -5.84806 3.10051 +323 1 0.855781 1.46858 5.93628 -12.4576 1.96544 0.341226 +324 1 8.11454 2.43493 5.75559 5.15623 -3.74122 1.07022 +325 1 1.70238 1.57115 5.35189 -38.5773 5.62525 -16.043 +326 1 2.46473 3.0428 4.8535 14.9609 2.21644 20.6584 +327 1 2.4829 2.11442 5.80082 20.2757 20.5564 -2.76238 +328 1 1.44662 2.4329 5.9576 0.543772 11.9562 -7.2005 +329 1 3.29597 2.05528 5.06702 2.85074 -1.27902 5.48838 +330 1 4.71392 2.67227 4.67311 -16.586 -2.70867 4.26173 +331 1 4.23981 1.93327 5.61065 17.5416 10.5589 -1.008 +332 1 3.69151 2.91031 5.72032 0.213325 2.13196 -1.69169 +333 1 5.26041 1.83667 5.02123 6.06702 -8.01086 0.159199 +334 1 6.29681 2.56022 5.09106 -5.44623 -0.683824 -15.8447 +335 1 5.97089 1.97948 5.90875 -1.39581 -8.65091 2.36208 +336 1 5.32016 2.78712 5.54952 10.0834 -7.57686 9.12967 +337 1 6.76335 1.53665 5.10381 -6.49311 3.28388 -1.62508 +338 1 7.39244 2.59867 4.94069 -6.65618 -18.4022 10.6664 +339 1 7.39034 1.59037 5.98163 7.99848 2.50507 -1.85372 +340 1 6.86792 2.60296 5.96513 8.836 -3.98323 2.68287 +341 1 0.137435 3.52069 4.93684 -4.66205 -5.7882 5.56144 +342 1 0.88525 4.34994 4.6075 2.988 -8.04302 19.8618 +343 1 0.671447 3.60221 5.79043 18.0943 -16.6493 20.2037 +344 1 8.34285 4.28087 5.95434 -19.6744 13.1619 0.969809 +345 1 1.33416 3.36295 4.99473 8.92189 5.92429 -2.5153 +346 1 2.50305 4.23267 5.05465 -27.5248 -20.908 0.492103 +347 1 2.36725 3.37012 5.84923 -17.1073 -9.96579 7.0021 +348 1 1.45211 4.29673 5.57493 7.54138 6.26423 2.50823 +349 1 3.47656 3.71778 4.99943 12.588 -10.9937 -32.8348 +350 1 4.53758 4.28685 4.7978 -5.49767 21.5926 5.59595 +351 1 4.66123 3.56451 5.54467 -12.8933 9.0868 3.25853 +352 1 3.16215 4.0016 5.8872 6.62501 12.8548 34.5501 +353 1 5.39268 3.59146 4.74919 -4.73905 -31.3011 -11.4087 +354 1 5.76113 4.47956 4.9574 18.7428 32.3973 -5.18443 +355 1 5.78815 3.80587 5.78982 -7.10304 0.117864 -2.90029 +356 1 5.02789 4.67913 5.68892 -14.5359 -3.59396 7.83253 +357 1 6.67716 3.56196 5.1655 1.61752 2.79183 -0.67852 +358 1 7.59448 4.24592 4.9803 -6.50366 -1.98045 6.72657 +359 1 7.59718 3.39514 5.76655 2.21878 7.1556 0.646608 +360 1 6.80163 4.43627 5.8851 -3.03056 -0.645399 -10.9559 +361 1 8.29576 5.01058 4.81068 0.626199 13.0736 14.2059 +362 1 1.05047 6.19551 5.02762 -0.156468 -7.32209 -14.0064 +363 1 0.578297 5.15849 5.72641 1.63655 2.26956 0.551951 +364 1 8.23943 6.07268 5.87533 8.87399 -0.526239 1.15285 +365 1 1.76527 5.31835 4.93011 -1.00084 -16.0238 11.4126 +366 1 2.88183 5.91468 5.07925 -22.1885 -17.105 2.25231 +367 1 2.65936 4.93415 6.03537 0.686882 11.6758 -2.90902 +368 1 2.03447 5.84592 5.92534 2.47635 -18.2138 -25.6325 +369 1 3.24392 4.86959 5.11086 62.6624 1.69747 54.073 +370 1 4.07402 5.91621 4.83335 -4.98562 8.578 9.29517 +371 1 3.92826 4.74513 6.11781 2.52773 6.36319 -4.5061 +372 1 3.44964 5.83627 5.89312 16.6713 -3.51566 20.823 +373 1 5.12814 5.53194 4.84592 -22.4422 -5.59515 37.2611 +374 1 5.90308 6.17208 5.1146 -12.9736 21.9443 6.65273 +375 1 5.95357 5.13374 5.81819 6.93561 8.02219 4.14964 +376 1 4.75268 5.76162 5.94655 1.5775 -0.40438 -5.87077 +377 1 6.51586 5.41565 4.90612 17.2134 -26.1979 -1.37429 +378 1 7.5279 5.93793 5.01527 -3.38884 15.9345 -12.1825 +379 1 7.6332 5.21687 5.72128 4.22628 -40.3472 -14.2075 +380 1 6.64022 6.14894 5.87989 13.3598 -6.13205 -0.934618 +381 1 8.34458 6.85129 5.15926 -14.2808 -7.95422 -4.25663 +382 1 0.833911 7.25078 4.85532 9.11386 4.17832 -8.89911 +383 1 1.06673 6.48225 6.01607 -14.203 -6.44505 8.15493 +384 1 -0.0379195 7.65497 5.88016 -1.75378 4.76646 1.63712 +385 1 2.12599 6.69323 4.98422 2.81787 34.3524 37.6883 +386 1 2.84758 7.50703 5.20442 -10.9987 17.1664 -16.5728 +387 1 2.77128 6.71691 5.85642 -9.44911 -10.1768 15.1935 +388 1 1.58013 7.32255 5.72901 16.1676 5.29147 -4.24753 +389 1 3.6768 6.91779 5.33962 13.4611 -20.8664 1.96557 +390 1 4.03881 7.88236 5.22897 2.57592 -0.812644 -11.9679 +391 1 4.4232 6.75921 6.19682 -8.5477 -5.71312 7.44018 +392 1 3.24799 7.72667 6.18249 0.719386 0.220585 -2.48264 +393 1 4.83295 6.89566 5.2507 4.97045 -2.42982 -4.77289 +394 1 5.87897 7.61282 5.14968 -20.2612 -0.49131 -22.7769 +395 1 5.75942 6.67532 6.09541 -7.34504 3.57141 -0.447292 +396 1 5.14318 7.54839 6.30602 2.0724 10.313 -0.219969 +397 1 6.74639 6.92855 5.00696 6.96871 -0.230218 1.29861 +398 1 7.3805 7.8124 5.23875 7.69485 -10.0795 -7.08489 +399 1 7.52596 6.88746 5.90198 -6.42674 1.56965 2.19774 +400 1 6.51888 7.44621 5.87193 29.4637 -7.18826 32.3539 +401 1 8.28476 0.000423359 6.72306 2.02553 19.5279 -19.3713 +402 1 1.01888 0.905848 6.82221 -28.6303 -12.8009 -18.3361 +403 1 1.24262 8.30657 7.44334 -32.4348 0.998186 -42.9826 +404 1 0.0211475 0.824091 7.47144 0.973424 -13.5355 3.24171 +405 1 1.94007 8.12144 6.72811 7.36532 0.254467 -18.2635 +406 1 3.02097 1.5587 6.75498 -16.6323 -17.6578 -2.8331 +407 1 2.39982 0.0370076 7.66598 -2.14889 1.34284 -3.48663 +408 1 1.9688 0.847456 7.09398 30.835 -18.1107 26.5169 +409 1 3.29942 8.17609 7.18194 3.78499 -8.25924 -8.09048 +410 1 3.92844 1.06207 6.75726 8.02723 -15.5891 -9.47025 +411 1 4.52946 0.167766 7.50023 3.36063 -0.839689 -4.02118 +412 1 3.29302 0.728616 7.56048 2.70434 15.6737 2.80228 +413 1 5.10415 0.332413 6.57695 -15.8309 -23.3459 -1.79261 +414 1 5.90656 0.845621 6.88018 -8.12621 13.928 11.6173 +415 1 5.71058 8.18101 7.57391 -10.3063 5.31817 -1.8554 +416 1 4.82988 1.18118 7.265 13.8593 7.32067 6.7543 +417 1 6.57919 8.43785 7.00021 11.8406 5.1504 -4.86933 +418 1 7.5282 0.806752 6.77786 -1.5451 6.42857 5.82496 +419 1 7.48349 8.33572 7.57521 5.34797 11.8467 16.9658 +420 1 6.70557 1.08836 7.47923 9.5713 -7.54062 13.1357 +421 1 0.0382442 1.56126 6.72749 -0.0966071 11.4911 -0.854867 +422 1 0.869187 2.34639 6.83989 -3.61656 -2.89703 1.60294 +423 1 0.999275 1.45672 7.67633 -8.0034 9.48038 5.5647 +424 1 0.139215 2.63275 7.64328 -15.7892 -20.5267 5.19008 +425 1 1.88893 1.53066 6.37684 -7.83006 6.68056 5.79142 +426 1 2.1935 2.73769 6.82665 18.0903 -33.7124 -24.8324 +427 1 2.37018 1.89864 7.50076 -8.8745 -17.5059 -13.2094 +428 1 1.48561 2.41457 7.71452 -8.23366 6.90197 4.22635 +429 1 3.39063 2.48859 6.68098 16.1595 11.6225 -22.1191 +430 1 4.55604 3.04369 6.47522 -16.239 -17.1818 -0.0461326 +431 1 3.92972 1.83682 7.47298 10.0225 0.0134714 -13.9461 +432 1 3.03012 2.73851 7.57823 -7.17652 4.30522 18.5475 +433 1 5.02119 2.07008 6.4546 -13.5258 -22.6225 -4.75661 +434 1 5.65211 2.81921 6.68199 10.7014 16.4385 -2.46135 +435 1 5.81386 1.77715 7.51287 -3.39579 0.139075 -0.667502 +436 1 4.71678 2.54344 7.41951 15.4924 -28.3106 -11.236 +437 1 6.66707 1.83619 6.71865 -2.24275 1.62817 8.66814 +438 1 7.65934 2.42567 6.78337 1.29364 23.1589 -24.9484 +439 1 7.60492 1.76056 7.50233 6.44148 -25.2098 19.19 +440 1 6.42541 2.6971 7.41321 1.20391 11.9169 -7.49803 +441 1 0.132604 3.18129 6.70867 -2.29445 4.14817 -3.79866 +442 1 0.662351 4.17412 6.80772 -12.4952 0.818831 -9.43638 +443 1 0.788837 3.4069 7.65946 13.9586 12.3209 -0.784492 +444 1 8.14087 4.12742 7.481 16.3072 -9.43806 5.16356 +445 1 1.48457 3.42655 6.6105 -23.5819 5.37731 -5.67472 +446 1 2.19532 4.19793 6.62241 18.5812 -12.748 4.0704 +447 1 2.03418 3.35836 7.57671 1.74798 18.3537 22.2752 +448 1 1.46881 4.26381 7.4306 10.5669 6.85755 16.1187 +449 1 3.40116 3.57046 6.96596 -19.5489 -14.8384 -6.51121 +450 1 4.14086 4.23036 7.04697 14.6332 24.1596 -34.0677 +451 1 4.37587 3.46381 7.58097 -0.667569 -11.1793 25.3659 +452 1 3.3081 4.23862 7.84495 3.59222 -23.7983 19.5534 +453 1 5.02719 3.92296 6.55308 10.3874 19.2736 1.42121 +454 1 5.99108 4.37569 6.77029 -42.1869 -21.9594 -11.1356 +455 1 5.60639 3.61515 7.4373 -8.14506 -14.6497 -3.14446 +456 1 5.05417 4.46396 7.7264 -7.96475 -5.84314 -22.6526 +457 1 6.56389 3.51182 6.41915 7.41692 -2.85266 9.06964 +458 1 7.47152 4.32616 6.69237 -6.16955 -7.38805 -5.63513 +459 1 7.53898 3.20716 7.62579 -2.06037 -6.09637 -1.14724 +460 1 6.59589 3.90993 7.45755 23.4751 -0.996001 13.7582 +461 1 8.21483 5.0816 6.83956 12.3265 -1.95746 -0.89439 +462 1 0.465403 5.98278 6.74845 -2.0373 -17.3355 -17.4636 +463 1 0.511394 5.19401 7.82937 -10.2185 -4.74355 -3.50015 +464 1 8.12271 6.05839 7.46163 -7.84524 3.1436 -8.24587 +465 1 1.48514 4.9291 6.5693 -9.22109 4.87392 -22.494 +466 1 2.40623 5.73649 6.97099 14.0591 -30.3418 -0.240996 +467 1 2.41461 4.96776 7.80425 -3.8539 -8.74065 -18.3704 +468 1 1.44923 5.49011 7.41 13.6015 -14.5185 13.7078 +469 1 3.24542 4.75566 7.0008 -15.7357 21.5396 -25.2781 +470 1 4.03587 5.88736 6.84618 18.4928 -13.3364 -12.8531 +471 1 4.10808 5.01612 7.64484 -5.1777 21.728 20.8534 +472 1 3.29694 5.8019 7.54893 0.566822 -11.9233 11.3035 +473 1 4.81889 5.07278 6.77721 5.06549 -4.43332 1.49875 +474 1 5.96641 5.77692 6.72214 -33.9279 46.677 -28.2473 +475 1 5.88193 5.34623 7.60234 -1.49551 -23.3855 17.2998 +476 1 4.83941 5.81133 7.62234 25.0546 -26.9624 -0.550707 +477 1 6.63577 5.08354 6.75153 63.1873 3.33413 5.12133 +478 1 7.44477 5.7383 6.53202 -8.94815 26.2377 30.0386 +479 1 7.45353 4.90407 7.60234 6.61529 10.6464 -15.3985 +480 1 7.05207 6.05238 7.85033 -15.5225 4.97074 -5.49642 +481 1 8.33549 6.95757 6.75022 0.367032 -2.97861 0.255273 +482 1 0.891414 7.50932 6.49478 -4.83629 2.79466 11.3618 +483 1 1.06555 6.40917 7.42656 -9.40876 15.4887 12.6203 +484 1 0.19507 7.80618 7.47535 7.27195 -18.2248 4.26121 +485 1 1.90915 6.5235 6.63557 -10.6214 46.709 18.7487 +486 1 2.60482 7.35009 7.06318 -2.87326 8.86923 -10.12 +487 1 2.54785 6.52686 7.66612 -14.5904 -1.60347 8.59865 +488 1 1.54201 7.28494 7.4147 7.26892 14.9372 -8.95427 +489 1 3.42163 6.7113 6.72693 -9.74068 0.0780566 2.81617 +490 1 4.07503 7.52705 6.85904 11.3718 5.59625 6.13428 +491 1 4.17032 6.5317 7.69612 -24.7224 6.99609 -12.8841 +492 1 3.30541 7.28919 7.8835 -6.45113 3.62128 -9.60987 +493 1 5.18135 6.6767 7.03146 3.30189 -12.2169 -7.11599 +494 1 6.1441 7.48882 6.87735 -8.40006 -9.95553 -2.76953 +495 1 5.99111 6.52776 7.79328 26.4283 6.66779 -19.7705 +496 1 4.88188 7.45813 7.61707 18.1033 18.9899 -14.9739 +497 1 6.70265 6.55612 6.94114 4.37785 1.73726 -4.76735 +498 1 7.52255 7.69097 6.78657 -11.7433 -15.8982 -13.9562 +499 1 7.60662 7.23551 7.85952 12.3776 -11.2962 -9.39843 +500 1 6.63368 7.62048 7.85195 7.88485 3.15928 -11.7162 +ITEM: TIMESTEP +300 +ITEM: NUMBER OF ATOMS +500 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +ITEM: ATOMS id type x y z f_2[1] f_2[2] f_2[3] +1 1 0.233349 8.13006 8.37458 -13.2268 13.2109 8.94155 +2 1 0.896766 0.85308 8.30255 3.22629 3.6978 6.45643 +3 1 0.859864 0.0707018 0.945242 -23.4126 -16.0712 -18.9613 +4 1 0.0588758 0.842768 1.07285 9.62638 -2.91549 -12.4893 +5 1 1.77938 8.21846 0.149185 -27.8434 -16.3109 -1.32989 +6 1 2.24018 0.700289 8.36085 16.269 9.92358 -3.41709 +7 1 2.6315 8.21417 0.711168 13.3859 0.245092 -3.82819 +8 1 1.39092 0.935915 0.985394 12.7346 13.01 -5.10945 +9 1 3.3176 8.39636 8.17869 -11.566 -16.9274 13.6338 +10 1 3.85219 0.815062 0.0370236 10.4004 28.9589 -3.67884 +11 1 4.161 0.0319779 0.627546 1.75904 -7.59281 -2.75644 +12 1 3.11636 0.817642 0.847547 4.80203 -27.6102 -6.44654 +13 1 5.13793 8.3571 8.28888 -5.17208 4.97346 2.0085 +14 1 5.70385 0.905818 8.12031 -17.8373 19.4407 -6.83741 +15 1 5.79877 0.0963845 0.817928 -4.38032 -1.5507 0.666839 +16 1 4.98412 1.21117 0.664665 -21.555 -8.66432 0.346644 +17 1 6.45061 0.296088 8.38812 3.42924 -28.9348 -2.0588 +18 1 7.77702 0.350545 0.295684 -0.731277 11.544 -2.82186 +19 1 7.70462 8.17101 1.16161 -8.03851 17.5755 -13.9844 +20 1 6.86494 0.586624 0.875444 5.58847 2.16197 13.2587 +21 1 0.100678 1.61145 0.0186749 -1.1873 -11.6656 4.66894 +22 1 0.998429 2.3998 8.22988 -7.28085 -4.5005 5.89326 +23 1 0.828996 1.87962 0.867267 -19.2592 -9.93125 -3.90703 +24 1 8.27374 2.4894 0.580898 8.78255 -11.7455 7.53659 +25 1 1.74048 1.62493 8.26739 -9.18296 -12.9889 2.92816 +26 1 2.39558 2.37629 0.0600193 9.87685 24.4855 1.90731 +27 1 2.45445 1.58898 0.877492 -32.2642 -6.64837 2.63885 +28 1 1.65243 2.45558 0.846906 19.966 -6.37675 -0.113589 +29 1 3.02408 1.54485 8.35689 5.59986 -7.64836 -2.85923 +30 1 3.92 2.20197 8.38732 -20.8443 12.2841 2.52306 +31 1 3.77985 1.57027 0.846646 20.9907 13.6119 -1.22324 +32 1 3.10388 2.34584 0.944358 6.32701 23.9593 -3.77688 +33 1 4.85706 1.878 8.25981 8.11354 -3.87323 -9.47245 +34 1 5.78268 2.09333 0.29673 -1.36849 16.4599 4.03726 +35 1 5.97863 1.20376 0.790291 32.0463 2.36619 -11.4383 +36 1 4.88385 2.45634 0.850397 9.78281 -16.7958 -1.62774 +37 1 6.62285 1.61835 8.29579 8.05661 -4.4773 5.02204 +38 1 7.55399 2.56197 8.18132 12.8994 -8.38166 15.4695 +39 1 7.59924 1.47112 0.768275 -0.340381 -2.67871 -5.54587 +40 1 6.74877 2.64386 0.753723 -17.0902 -18.9793 -10.4389 +41 1 8.35722 3.30339 8.29621 3.88209 -7.05803 1.13469 +42 1 0.765977 3.99405 0.477073 10.4517 2.49603 -17.2656 +43 1 0.831221 3.06707 0.900453 -8.35587 -6.78904 7.02328 +44 1 0.140436 4.39767 1.19127 -1.57081 11.5239 1.23833 +45 1 1.55351 3.27393 8.36662 -0.118073 6.26889 7.92677 +46 1 2.48303 4.16731 0.14908 -13.7582 -4.26857 1.92322 +47 1 2.37333 3.17517 1.02067 -14.4692 6.50264 -31.5071 +48 1 1.65701 4.17058 1.15287 -1.5797 -1.97941 -12.8817 +49 1 3.21438 3.21157 0.146996 -20.1594 -11.7694 11.9952 +50 1 4.28321 4.06082 0.235561 -7.01013 0.464645 -7.4456 +51 1 4.00184 2.96868 0.822048 -4.54826 25.7516 -18.5713 +52 1 3.26412 4.08833 0.821613 11.1851 4.36305 6.27367 +53 1 4.93889 3.19103 0.0459746 -2.17639 -1.1271 -7.48927 +54 1 5.93535 4.0528 8.21654 -1.56333 -1.65165 1.96928 +55 1 5.75576 3.15988 0.707778 17.6817 -13.2713 5.13403 +56 1 5.2315 4.02943 0.763223 -0.452475 -6.04463 7.12931 +57 1 6.80967 3.18308 7.98158 -23.2698 3.29018 18.9116 +58 1 7.84937 4.15894 0.139115 -10.2897 11.6744 2.993 +59 1 7.56351 3.24008 0.752033 -0.468845 18.0521 -12.3044 +60 1 6.70326 3.88955 0.624889 -0.941138 0.59008 2.25635 +61 1 0.263315 4.89557 0.260533 -21.3177 5.01328 -15.5704 +62 1 0.767954 5.80979 8.30607 7.59978 -5.84563 1.67074 +63 1 1.01162 5.03409 0.908989 7.54529 2.69929 16.3999 +64 1 8.38725 5.83431 1.00337 3.61589 -4.15339 -6.36164 +65 1 1.65923 4.84747 0.0732901 -12.2718 -7.14452 -1.11973 +66 1 2.34253 5.60198 8.30655 7.91513 22.3685 24.006 +67 1 2.47075 4.92775 0.922768 -5.69599 3.89765 2.66746 +68 1 1.65076 5.8624 1.08155 8.28384 13.1663 -26.7168 +69 1 3.21032 4.96288 0.0718385 6.90275 12.0583 4.83562 +70 1 4.31683 5.81091 8.2445 -6.07106 16.001 24.4162 +71 1 4.0022 5.10933 1.08243 -0.987394 -5.51353 -4.14418 +72 1 3.08952 5.8543 1.08001 20.7019 -13.8856 -23.646 +73 1 5.04193 4.8848 0.236201 -6.75887 8.84809 -11.6728 +74 1 6.01036 5.86922 0.147762 0.616812 -0.708561 -9.8882 +75 1 6.00591 4.76669 0.704892 -5.00399 3.30231 -11.9912 +76 1 5.15986 5.7957 0.727818 -36.1273 9.99449 -4.0864 +77 1 6.87642 4.89744 0.140008 2.16293 1.86546 -13.7103 +78 1 7.84039 5.5603 8.24691 -4.77039 2.45387 6.97935 +79 1 7.61247 4.95216 0.884224 61.5464 5.54866 -31.4574 +80 1 7.13999 5.87097 0.66837 -10.4004 0.446979 -1.0889 +81 1 0.284976 6.68434 0.215945 -19.2498 8.05662 -14.0567 +82 1 0.982876 7.472 8.30358 11.1034 -5.67626 13.795 +83 1 0.874256 6.63686 1.03265 -11.7399 -6.70777 -2.09767 +84 1 0.12523 7.53526 1.06205 -15.5002 -8.52158 -32.9301 +85 1 1.53836 6.56542 0.124336 5.81155 -2.74575 2.70263 +86 1 2.45566 7.24014 0.163939 -13.7862 7.0524 3.90305 +87 1 2.38368 6.64181 1.16489 5.19309 13.0368 -14.4547 +88 1 1.55777 7.42064 0.955187 2.95317 9.919 -9.12596 +89 1 3.26105 6.57879 0.277391 6.19764 -3.88127 -4.29904 +90 1 4.21681 7.50418 8.36589 0.418779 7.33048 -0.673966 +91 1 4.2136 6.71573 0.805769 6.02261 -2.81289 0.798739 +92 1 3.49573 7.57967 0.77094 -13.8185 -15.1907 -22.6007 +93 1 4.97943 6.65519 6.77102e-05 6.49698 2.41559 -0.5205 +94 1 5.78763 7.50739 0.0292034 7.17211 6.93093 1.18788 +95 1 5.70061 6.80412 0.815144 6.83872 -8.02569 -5.22668 +96 1 4.96155 7.64188 0.754906 -1.40971 0.48378 3.60676 +97 1 6.62543 6.75834 0.212141 20.3815 -6.72799 19.0936 +98 1 7.5054 7.54064 0.228699 5.02405 -0.59125 8.31674 +99 1 7.62741 6.7648 0.966544 10.8528 -1.51524 -6.86782 +100 1 6.51764 7.61106 0.794066 -3.58188 15.2202 -2.22905 +101 1 0.0861403 8.39942 1.77523 16.561 5.47177 12.0456 +102 1 0.798241 0.867486 1.90283 5.83429 -6.22483 -1.18959 +103 1 1.01882 8.16093 2.58804 1.69129 37.21 2.68102 +104 1 8.26047 0.933232 2.39213 16.6191 -6.94084 19.3019 +105 1 1.5043 8.31602 1.70005 24.5225 8.22354 6.48742 +106 1 2.3278 0.505699 1.44491 -1.87805 7.24432 12.5632 +107 1 2.30107 0.0675885 2.61736 -2.34035 -25.4089 0.204635 +108 1 1.65389 0.877547 2.65941 -7.28266 6.33447 -16.1438 +109 1 3.50019 8.31721 1.47862 -16.7888 14.1081 10.898 +110 1 4.01956 0.825924 1.54962 -26.8746 12.2857 6.16059 +111 1 4.07538 0.019132 2.44171 -4.87493 0.404402 -2.17065 +112 1 2.869 0.885962 2.4149 5.17917 -2.47967 0.533766 +113 1 4.73464 0.155071 1.4932 30.6868 -26.2406 6.98684 +114 1 5.62968 0.817396 1.64834 -4.04481 -8.77462 16.8173 +115 1 5.66865 0.0141325 2.50366 17.0023 -1.89327 -13.9307 +116 1 4.86842 0.817468 2.42132 32.27 -13.4362 -6.77265 +117 1 6.59541 8.31415 1.73549 -0.21361 15.3936 4.52423 +118 1 7.59767 0.742823 1.6565 -21.3952 4.75735 -8.6823 +119 1 7.60945 8.3635 2.38741 -3.47518 -4.35582 8.08118 +120 1 6.64964 0.766964 2.59458 1.86331 7.94862 -15.7507 +121 1 0.0966564 1.72383 1.66126 -2.3646 2.96568 -2.77323 +122 1 0.838875 2.52792 1.96878 -8.15441 10.7797 -1.95863 +123 1 0.90776 1.65168 2.68747 -10.1162 -2.78056 -2.47535 +124 1 8.34426 2.2614 2.55151 21.19 -10.0612 15.2043 +125 1 1.46427 1.72978 1.76157 8.28796 -9.22695 -3.48387 +126 1 2.37501 2.29161 1.76614 -0.0664736 7.90276 1.49641 +127 1 2.67166 1.85508 2.81423 -4.33867 8.71682 -6.36279 +128 1 1.69129 2.40006 2.69001 -6.84808 74.503 -77.1336 +129 1 3.2606 1.69371 1.92128 -6.02725 -3.6159 -16.3817 +130 1 3.94104 2.38885 1.63591 5.99851 11.0997 18.049 +131 1 4.04449 1.32304 2.52718 -28.9333 17.8748 13.0885 +132 1 3.64404 2.34301 2.71879 -4.29604 2.09188 -4.97764 +133 1 4.64091 1.6418 1.58405 19.1918 -0.189122 5.88078 +134 1 5.88395 2.31133 1.52544 0.0797298 5.40617 -9.4435 +135 1 5.7987 1.64961 2.35436 -3.46325 -3.79932 12.9903 +136 1 4.78244 2.22308 2.51874 2.01011 -1.75623 -4.81914 +137 1 6.65439 1.55727 1.69251 0.0481382 -10.7878 -2.86985 +138 1 7.4609 2.22018 1.51079 9.36137 15.4008 -1.67913 +139 1 7.50576 1.63853 2.4128 -2.97032 -17.2864 -0.621812 +140 1 6.87214 2.43415 2.42038 -30.5876 3.19651 2.74052 +141 1 8.27498 3.12542 1.46263 16.9155 1.32854 13.6822 +142 1 0.778659 3.95642 1.86807 -7.25106 -12.2522 -5.40095 +143 1 0.798965 3.10856 2.99966 -8.51883 26.4353 -21.6316 +144 1 8.39629 3.85082 2.58225 -5.99614 1.48776 4.40527 +145 1 1.68381 3.21805 1.79101 -5.77633 -5.0861 7.47296 +146 1 2.56903 4.03114 1.71918 -6.92524 18.9919 2.42009 +147 1 2.68821 3.054 2.58052 -0.955464 -0.812242 -0.180548 +148 1 1.68992 4.20726 2.20027 5.368 3.11181 32.2719 +149 1 3.19042 3.29104 1.54336 50.4233 -29.9172 14.5641 +150 1 4.30208 4.0236 1.30142 -3.92395 -1.77865 11.4065 +151 1 4.28898 3.18994 2.59219 8.96711 6.3942 -10.7611 +152 1 3.60727 4.0096 2.21837 0.742083 4.13896 4.48687 +153 1 5.11886 3.09922 1.66619 -2.87182 6.36609 5.71268 +154 1 5.98984 4.3721 1.6574 7.23512 -22.1503 15.9695 +155 1 6.06757 3.38048 2.48886 -0.631751 -1.09061 1.54872 +156 1 5.04095 4.05582 2.29794 7.98224 -6.57422 -3.38111 +157 1 6.80585 3.23363 1.61955 1.81547 4.43083 5.90353 +158 1 7.6107 4.12271 1.4985 -13.6918 -18.0547 7.51636 +159 1 7.71076 3.00605 2.3508 1.14441 21.4666 -12.0177 +160 1 6.92831 4.10176 2.31565 -3.92153 2.58619 4.8482 +161 1 8.33973 5.1724 2.08404 -22.306 -14.8391 -35.8531 +162 1 0.860537 5.83051 1.79504 -25.5953 10.3696 1.23396 +163 1 0.802813 4.96181 2.52052 20.0549 -14.1798 16.2425 +164 1 8.20479 5.88748 2.7573 8.86056 43.8975 -14.7096 +165 1 1.62556 5.15881 1.79421 13.6671 -60.0224 -43.8322 +166 1 2.44832 5.82052 1.83706 -21.0979 -8.85922 15.9808 +167 1 2.35829 4.95884 2.60055 5.56499 -3.25718 -17.7316 +168 1 1.57047 5.68188 2.57793 3.26945 48.3874 60.3367 +169 1 3.12962 4.94115 1.79611 3.44797 3.66295 -7.67081 +170 1 4.533 5.88518 1.61818 -3.82507 3.84853 0.541056 +171 1 4.41047 4.91386 2.27111 -7.04817 9.97354 -0.554451 +172 1 3.1705 5.97206 2.56867 13.8835 0.36015 7.54685 +173 1 5.10201 4.84379 1.45925 -8.99072 13.7146 -7.42642 +174 1 6.04077 5.71462 1.17105 24.8221 7.94918 20.2395 +175 1 6.02655 5.34395 2.16117 8.67798 2.32994 -0.236737 +176 1 5.13754 6.13757 2.45889 -19.0768 2.88926 -22.199 +177 1 6.81157 4.98564 1.3948 -36.2833 4.79272 33.0954 +178 1 7.60086 5.99469 1.7372 -3.24829 -8.45789 -2.93345 +179 1 7.33283 5.34101 2.57932 2.07328 -12.097 -6.46632 +180 1 6.77196 6.24125 2.34214 -17.3674 -5.70799 13.1243 +181 1 0.0250537 6.6606 1.72753 8.49396 4.93702 8.33356 +182 1 0.795762 7.59079 1.77266 12.7999 -27.3678 15.1487 +183 1 0.926657 6.70523 2.69571 -0.793657 3.91691 -3.18748 +184 1 0.160908 7.59778 2.74546 -5.44053 4.97464 -19.9661 +185 1 1.54893 6.69469 1.77147 8.37496 4.15768 30.0144 +186 1 2.38553 7.66265 1.59156 1.85092 -2.31642 6.75994 +187 1 2.52893 6.74213 2.34554 9.20138 12.1517 -25.6716 +188 1 1.80175 7.4451 2.61158 -6.78811 17.5009 -13.1399 +189 1 3.38458 6.74038 1.57533 -10.1646 -3.59545 3.61897 +190 1 4.095 7.47851 1.58866 27.0187 15.4009 2.51878 +191 1 4.11379 6.83 2.37783 19.5598 -18.1657 -14.1463 +192 1 3.12959 7.71074 2.36405 10.6634 -2.49932 -15.2866 +193 1 5.08729 6.94297 1.62592 -21.1801 -24.4484 5.07107 +194 1 5.73581 7.71377 1.57745 5.16642 11.3097 -0.890489 +195 1 5.92001 7.08484 2.45291 -0.193261 -0.933403 -1.70059 +196 1 4.83819 7.59024 2.39768 8.18574 14.9342 11.0206 +197 1 6.61545 6.66525 1.38958 -18.6406 -25.8802 -11.2439 +198 1 7.15994 7.45994 1.57935 11.6501 4.19084 33.778 +199 1 7.56748 6.9114 2.40976 10.0926 4.81165 9.43494 +200 1 6.80428 7.72449 2.78938 -1.24224 -1.60677 -10.8659 +201 1 0.159784 0.136544 3.24366 -1.32953 4.05967 1.66335 +202 1 1.00698 0.811307 3.51207 1.50245 1.78035 6.01503 +203 1 1.34713 0.12551 4.66914 -24.521 -31.0514 3.16868 +204 1 0.0655245 0.668593 4.25847 -0.855275 2.59789 -3.35749 +205 1 1.74942 8.37675 3.57933 -10.207 -16.1779 -1.21978 +206 1 2.26863 0.82911 3.48792 22.6881 17.8048 9.09595 +207 1 2.33553 0.183914 4.4711 16.8323 -1.13179 -15.08 +208 1 1.7049 1.03332 4.4695 6.78822 33.3459 -7.07653 +209 1 3.29237 0.411287 3.32326 -2.12858 -4.79866 -0.866625 +210 1 4.21141 0.796867 3.72276 15.2258 15.2508 -15.0202 +211 1 4.33441 8.33993 4.30342 13.6521 7.25398 3.1725 +212 1 3.45786 0.725922 4.42039 -13.4693 -6.1715 4.46767 +213 1 4.89231 0.0473082 3.15782 -6.25621 1.30634 20.3282 +214 1 5.77362 0.736119 3.37748 -9.09312 1.23928 -13.4649 +215 1 5.99071 8.04065 4.47949 -15.8189 13.2428 -8.46949 +216 1 5.196 0.682234 4.2587 4.7081 -6.90451 -0.266688 +217 1 6.57106 0.145322 3.40637 19.3462 -23.2913 17.9258 +218 1 7.59401 0.663732 3.46257 -2.8602 2.11131 -2.24016 +219 1 7.44242 8.25412 4.2449 1.11307 19.9225 9.74876 +220 1 6.62382 0.709572 4.35284 3.66026 3.16927 -3.64727 +221 1 0.0779483 1.38159 3.37319 -4.4953 5.38733 3.01304 +222 1 0.974278 2.30233 3.53228 -23.5961 -13.9704 29.7447 +223 1 0.524182 1.77379 4.53785 8.44119 -12.0369 -19.76 +224 1 8.32657 2.54461 4.19453 11.685 -8.01921 4.29442 +225 1 1.79699 1.78778 3.36592 20.9053 -94.2146 75.3552 +226 1 2.26904 2.65097 3.69138 3.64635 0.74501 -3.21688 +227 1 2.67429 1.70202 4.43144 -1.62218 -6.52331 -3.16444 +228 1 1.67869 2.25152 4.52595 21.8057 -26.9163 -24.6655 +229 1 3.42529 1.64095 3.50559 7.24234 -14.969 7.63922 +230 1 4.36843 2.51227 3.48596 2.07064 -5.87084 11.4812 +231 1 4.83369 1.71242 4.31187 -12.4342 -5.24453 -2.55025 +232 1 3.42697 2.55135 4.03879 13.1661 -11.4647 -6.22039 +233 1 5.09889 1.5127 3.30322 -10.1348 7.40169 -7.59726 +234 1 6.05204 2.45182 3.35855 -5.34479 4.21286 -4.99107 +235 1 5.91247 1.54121 4.03978 -1.19872 3.24833 9.47786 +236 1 5.34566 2.59829 4.30389 3.31953 7.26855 -16.7286 +237 1 6.74657 1.65018 3.27179 -23.12 -29.0051 -3.67746 +238 1 7.53263 2.23686 3.30386 26.344 22.8452 7.39879 +239 1 7.49613 1.58204 4.21155 10.9589 -18.8504 -4.35663 +240 1 6.70452 2.2326 4.19472 -13.7578 19.073 -7.70781 +241 1 8.04948 3.18864 3.48276 7.81989 17.0755 -15.6642 +242 1 0.420364 4.02026 3.62891 2.0762 -18.0048 -13.8871 +243 1 1.02911 3.20723 4.10028 2.87528 5.61338 3.46722 +244 1 8.23518 4.59996 4.24867 -9.72892 -14.3069 11.6196 +245 1 1.79813 3.62221 3.14835 -2.38332 -26.1643 0.00682256 +246 1 2.74246 4.09054 3.06778 10.2172 -0.241531 -5.01738 +247 1 2.65108 3.56469 4.0066 1.29528 2.95166 -0.450344 +248 1 1.68753 4.16642 4.41008 0.531244 0.36282 -0.905409 +249 1 3.56157 3.26659 3.34031 -15.156 16.0178 -13.2173 +250 1 4.30786 4.20161 3.07587 -3.71718 9.6458 -20.0534 +251 1 4.29173 3.71129 3.93288 2.63232 -25.6185 20.4798 +252 1 3.34785 4.41255 3.95574 4.30294 0.337698 1.30747 +253 1 5.19196 3.15058 3.27975 2.68017 7.34728 -0.723223 +254 1 6.11836 4.37563 3.09786 3.48097 -0.455645 -7.15348 +255 1 6.16379 3.4966 3.8024 -0.493793 0.0328113 2.1336 +256 1 5.30251 4.52711 3.80393 -16.2632 -25.1941 -0.0075048 +257 1 7.08947 3.30091 3.10932 -23.6486 5.19633 4.56168 +258 1 7.44697 4.43668 3.27896 -0.511887 -2.93371 -0.292771 +259 1 7.26132 3.68038 4.11877 19.5278 5.77559 -31.2062 +260 1 6.65227 4.59556 4.02535 -2.98634 0.729124 1.77093 +261 1 8.32438 5.07972 3.31456 7.45197 -18.3523 8.49382 +262 1 0.7239 5.87238 3.35063 13.9037 -7.68163 -11.6827 +263 1 0.86133 4.86733 4.0112 5.23908 17.06 9.33784 +264 1 0.110376 5.99228 4.15088 -19.5006 -5.14624 15.1727 +265 1 1.63326 4.60922 3.31023 -1.76723 17.8491 2.08855 +266 1 2.40135 5.61695 3.38494 19.4662 4.44663 -11.3673 +267 1 2.36184 5.08435 4.31966 -1.81965 -14.9274 -8.60789 +268 1 1.71701 5.94552 4.03684 -24.0402 -0.0953197 5.79012 +269 1 3.43912 4.9954 2.79577 7.89838 -10.7079 17.2388 +270 1 4.22838 5.86109 3.02821 33.6181 3.37383 -45.0173 +271 1 4.24887 5.06359 3.71273 2.64953 -0.546445 2.15952 +272 1 3.55742 5.92395 3.71083 -38.5919 -3.44905 39.4056 +273 1 5.41837 5.23828 2.98577 -11.447 -4.74628 10.7983 +274 1 5.86494 6.22754 3.11739 14.9731 7.40151 22.8162 +275 1 5.75467 5.37436 4.08221 13.6205 23.921 6.83069 +276 1 4.77382 6.13694 3.95439 -2.74813 -13.8938 10.4295 +277 1 6.55906 5.4789 3.24844 0.234698 -8.05013 11.4476 +278 1 7.53331 6.151 3.48116 -10.0459 9.16913 -20.7264 +279 1 7.59712 5.40949 4.12314 -10.2706 -23.4933 17.211 +280 1 6.76315 6.15422 4.20451 -8.32818 -2.13306 4.306 +281 1 8.33074 6.79274 3.30017 10.9969 -9.86444 14.3566 +282 1 1.03943 7.60681 3.41422 12.8839 -22.0033 7.43641 +283 1 0.876997 6.68124 4.1033 12.4942 12.9257 -7.86127 +284 1 0.320289 7.62896 4.11358 -19.9566 8.93301 7.64028 +285 1 2.12233 6.73507 3.25947 -6.36672 -13.9408 34.1069 +286 1 2.9278 7.71082 3.35699 -9.10575 13.9767 3.53664 +287 1 2.86555 6.96099 4.04549 -8.29151 -16.9355 4.68952 +288 1 1.89553 7.49272 4.25249 -6.95602 2.25366 -4.36835 +289 1 3.55128 6.82828 3.17739 -22.1877 4.18931 17.356 +290 1 4.1661 7.71123 3.4095 -5.10369 -4.69259 -0.796458 +291 1 3.89274 6.87937 4.19693 15.4298 1.82254 7.44647 +292 1 3.39266 7.95134 4.30177 -1.7872 -21.2114 -27.9517 +293 1 4.99714 6.86548 3.27273 -3.15325 15.5146 -9.80269 +294 1 5.7604 7.67976 3.37293 2.05238 1.22428 3.6757 +295 1 5.73479 6.76996 4.15088 6.33474 -4.66485 -1.392 +296 1 5.07616 7.57695 4.40446 -13.6351 -7.42167 0.514113 +297 1 6.73778 6.81794 3.33301 -3.54485 0.402493 -5.08336 +298 1 7.71498 7.67053 3.44695 -0.752689 -3.6099 -11.6949 +299 1 7.71759 6.87965 4.22182 -5.11403 5.07303 3.22293 +300 1 6.7649 7.45476 4.17956 6.56157 -12.3801 -0.724651 +301 1 8.19197 0.136233 5.17288 2.67067 20.6746 -19.9914 +302 1 0.776102 0.931351 5.08619 -1.70464 -8.91233 1.85235 +303 1 0.888781 0.0179834 5.65999 -4.55543 21.0031 13.534 +304 1 8.38466 0.737331 6.00004 -6.63761 5.81892 -3.68334 +305 1 2.17326 8.16764 5.48567 -30.0571 8.40977 9.50779 +306 1 2.68565 0.975823 5.34104 11.1467 5.8174 -19.2362 +307 1 3.06444 0.336871 6.1128 1.74673 -5.08128 15.5867 +308 1 1.94778 0.751629 6.0231 -12.5402 -6.77103 11.9096 +309 1 3.09215 -0.0018856 5.12048 23.3711 9.80891 31.3016 +310 1 4.54285 0.96074 5.03055 -10.8439 -8.47943 8.00065 +311 1 4.19772 8.25187 6.2874 -2.87662 7.25597 -11.3947 +312 1 3.73883 1.45482 5.73884 -5.31372 -3.16529 -7.8226 +313 1 5.15615 8.35466 5.42348 2.42368 -1.79965 -6.24325 +314 1 5.91471 0.891384 5.15303 -5.07011 -3.09253 -0.460458 +315 1 6.03745 8.35632 6.14961 -1.39208 3.8678 -5.18235 +316 1 5.2121 0.86593 5.98804 -13.8254 0.446509 -12.536 +317 1 6.68868 8.34181 5.14194 3.9888 6.48649 16.9974 +318 1 7.34021 0.809849 5.26372 -2.78853 -11.1974 -10.3326 +319 1 7.36245 8.30575 6.05369 1.98185 25.0408 -10.0092 +320 1 6.64158 0.85851 5.99168 -3.68623 1.19752 6.36998 +321 1 8.13309 1.40671 5.10096 17.8835 4.45702 -4.02515 +322 1 0.892662 2.59499 5.00421 -20.8235 21.437 24.4928 +323 1 0.773043 1.57142 5.91415 4.22614 9.86073 2.56515 +324 1 8.33239 2.57823 5.60038 -0.623629 0.0892147 1.2306 +325 1 1.87225 1.66498 5.43985 -2.48264 -4.0236 -4.58226 +326 1 2.75473 2.72259 4.73435 -30.311 11.1987 -1.55273 +327 1 2.93165 2.12687 5.49641 -1.73472 -35.7803 16.6222 +328 1 1.7335 2.58373 5.90704 -3.71318 12.7214 1.30751 +329 1 3.77896 1.69526 4.65032 1.63977 11.6216 2.36832 +330 1 4.33882 2.78478 4.62298 7.45227 7.00188 -24.1667 +331 1 4.0935 2.44339 5.52545 -11.3615 -7.17888 20.8862 +332 1 3.18285 3.03749 5.86709 11.7107 14.2608 -10.1303 +333 1 5.16253 1.77254 5.33362 4.38648 8.73211 2.03951 +334 1 5.9743 2.78241 5.0854 16.8461 0.569184 7.37091 +335 1 6.05449 1.8557 6.00418 -1.07841 -2.85482 0.754485 +336 1 5.02736 2.93607 5.49369 -0.394928 -5.32288 -0.0457358 +337 1 6.65738 1.68333 5.09298 2.04945 -3.50949 1.46808 +338 1 7.506 2.4535 4.81544 -2.36267 6.50792 21.426 +339 1 7.5049 1.81157 5.81254 2.0705 -7.66144 9.63716 +340 1 6.81799 2.57614 5.74327 -5.22025 12.4071 0.584392 +341 1 8.08209 3.4329 4.82809 -0.388102 0.733533 -0.302449 +342 1 0.687603 4.05264 4.91973 13.3113 7.10483 -26.1293 +343 1 0.927182 3.40713 5.70883 1.42 -2.21252 8.41121 +344 1 8.39125 4.08596 5.64374 -17.7983 3.69834 21.9629 +345 1 1.85335 3.18328 4.91159 -22.5662 10.1648 8.61749 +346 1 2.62594 3.83741 5.0269 -11.5374 29.2389 12.1219 +347 1 2.23001 3.64598 5.99431 12.2251 -19.0314 6.6066 +348 1 1.61612 4.36322 5.62412 -4.72812 -41.6645 3.65456 +349 1 3.49026 3.4159 4.80384 34.5623 1.92174 -9.26957 +350 1 4.42781 4.48169 4.58587 2.89283 12.0072 14.2383 +351 1 4.32987 3.73273 5.40213 -1.15236 0.923586 4.29704 +352 1 3.35747 3.99106 6.24745 4.6285 19.5949 -5.94829 +353 1 5.1733 3.66262 4.57851 -0.760359 -3.40804 -5.73178 +354 1 5.75745 4.60154 4.93992 12.48 38.3619 -39.183 +355 1 5.60952 3.84508 5.51193 1.72033 -36.6996 37.1733 +356 1 4.90838 4.64872 5.58962 -7.33472 10.9707 -1.22542 +357 1 6.81366 3.55073 4.97382 -24.7572 -16.3635 34.7513 +358 1 7.36231 4.42367 5.08055 17.1166 2.62568 -2.95463 +359 1 7.4725 3.41969 5.92572 4.71216 -0.444272 -3.67252 +360 1 6.56495 4.37474 5.82163 -0.033274 -9.82017 -6.2351 +361 1 0.041011 5.18659 5.08838 -22.5443 6.51501 -27.8507 +362 1 1.02655 6.1046 4.9959 -2.55187 -8.42255 -9.06362 +363 1 0.725543 4.91454 5.73466 12.2313 -2.94426 20.5318 +364 1 0.0422288 5.86356 5.87032 0.0942915 12.4442 -1.56822 +365 1 1.61098 5.19782 5.1268 2.44581 33.2387 -21.9348 +366 1 2.65636 5.69092 5.09384 11.8609 0.215073 14.2086 +367 1 2.6104 4.85981 5.98721 5.66035 -5.70161 -4.77737 +368 1 1.90538 6.1737 5.70769 -41.2624 -24.39 16.3086 +369 1 3.46858 4.77582 5.16944 -0.707582 -1.43422 0.766057 +370 1 3.76426 5.90532 4.89181 3.4437 -1.11423 -2.15979 +371 1 4.07073 4.92867 6.32743 11.4607 -11.4553 -4.32634 +372 1 3.67793 5.86643 6.05942 -4.35866 5.03724 -1.47182 +373 1 4.98792 5.51389 4.93524 -8.4187 -10.8933 -4.11136 +374 1 5.89023 6.01641 5.05179 11.0493 7.97987 -0.316877 +375 1 5.84913 5.21289 5.8287 7.09495 5.60009 -11.1489 +376 1 4.95887 5.92462 6.03819 -1.41241 -1.47294 -8.90972 +377 1 6.72618 5.24569 4.87739 -4.6501 10.2679 6.06598 +378 1 7.69701 6.07801 4.9728 1.45309 -5.4044 1.15049 +379 1 7.57443 5.25318 5.8022 -4.19719 -6.86637 2.5693 +380 1 6.75672 5.96198 5.84181 4.25859 -4.73277 0.116077 +381 1 0.149236 6.9327 4.88187 0.301354 -7.8021 16.5737 +382 1 1.06612 7.54377 5.19235 6.17987 -18.0682 -12.1896 +383 1 0.908663 6.67909 5.83913 1.89859 7.5565 8.00921 +384 1 8.3967 7.73373 5.73713 17.5958 -22.201 25.7152 +385 1 2.09262 6.53099 4.7967 1.84262 19.7267 -15.5304 +386 1 2.6809 7.4184 4.97144 1.84587 -3.02643 6.66108 +387 1 2.76451 6.5131 6.02372 26.4927 9.3308 7.09081 +388 1 1.89235 7.21971 6.07993 -5.61302 23.442 -46.1583 +389 1 3.56452 6.91614 5.29782 1.29026 -2.451 2.37678 +390 1 4.22056 7.80764 5.23329 -2.48711 -3.82055 1.83806 +391 1 4.29263 6.77471 6.12925 7.35038 5.5119 -5.7056 +392 1 2.85273 7.60961 6.07343 16.4578 1.27697 -7.39815 +393 1 4.81773 6.56695 4.97715 -1.40117 8.33727 3.10183 +394 1 5.78811 7.39325 5.43254 7.66799 3.74746 -17.7564 +395 1 5.91597 6.55237 6.07292 -10.3134 0.875812 3.19143 +396 1 5.1536 7.54901 6.2302 -8.62748 1.72241 13.4381 +397 1 6.84976 6.76387 5.09828 -3.19969 2.83039 -4.79256 +398 1 7.54117 7.72913 5.1763 -12.4453 -25.3207 -11.2598 +399 1 7.70324 6.72981 5.83369 -19.5261 3.79708 -10.3274 +400 1 6.77336 7.41197 5.93794 -9.93531 -0.946567 -12.2979 +401 1 8.22949 8.35705 6.76928 1.64244 -1.45449 1.77988 +402 1 0.72004 0.832942 6.72959 22.4465 -5.361 -6.29847 +403 1 0.883022 0.0931191 7.57241 -5.23405 -15.4407 -5.32038 +404 1 0.0468789 0.82113 7.48906 -16.6351 2.71194 14.972 +405 1 2.03902 8.21121 6.63645 7.11775 -8.1199 -7.72414 +406 1 2.8098 1.35985 6.35749 11.4457 2.58538 -2.95276 +407 1 2.39096 8.06897 7.6788 1.19633 7.68608 5.18448 +408 1 1.75996 0.580686 7.28683 6.89284 15.6237 4.36189 +409 1 3.24708 7.93738 6.98795 5.84043 19.9452 -24.3758 +410 1 4.23919 0.919929 6.46503 -1.07654 -9.91612 -5.08402 +411 1 3.90772 0.424381 7.41946 37.0812 -23.6824 -3.45202 +412 1 2.91871 0.505987 7.33506 -26.0302 7.74114 -11.0468 +413 1 4.92803 0.11282 7.09764 -8.28234 1.33652 -4.84063 +414 1 5.89475 1.0043 6.70526 7.29393 0.830325 27.9656 +415 1 5.8956 8.35718 7.44426 -3.02776 0.024361 13.8614 +416 1 4.71342 1.28665 7.29701 10.263 5.35948 11.5905 +417 1 6.8248 0.0574117 7.01961 11.7828 1.29904 -9.90689 +418 1 7.52034 1.04303 6.65362 -4.17639 -6.17679 3.43381 +419 1 7.73603 8.17986 7.79994 1.7859 4.36245 -17.9939 +420 1 7.13318 0.752429 7.78463 13.3591 3.5282 -5.71599 +421 1 8.39243 1.66394 6.67161 -0.134672 7.39125 4.10576 +422 1 0.854509 2.49412 6.65204 0.887161 -2.38052 0.586225 +423 1 1.18138 1.63924 7.31791 -41.6971 -18.352 25.0151 +424 1 0.0943458 2.334 7.66786 0.324396 10.57 -15.5201 +425 1 1.87867 1.74452 6.645 -1.95754 3.46436 -44.2754 +426 1 2.63684 2.47303 6.52845 -8.45632 -20.7999 4.28943 +427 1 2.51699 1.47554 7.37579 1.92109 3.65888 22.6814 +428 1 1.82876 2.39767 7.50566 14.4123 21.9409 0.136363 +429 1 3.78398 2.21463 6.57246 -2.68631 2.13236 -0.792617 +430 1 4.46308 3.07592 6.43555 -3.89191 7.33892 -9.13636 +431 1 3.59875 1.35397 7.20413 -9.98874 22.9069 2.08665 +432 1 3.19396 2.3577 7.56493 -2.6719 3.09783 -0.16421 +433 1 5.06299 2.1644 6.37533 -2.58633 -2.00836 2.79809 +434 1 5.67119 3.15784 6.34996 -0.566548 -6.83481 -5.10746 +435 1 5.66575 1.97666 7.57441 -14.7077 -20.3342 4.08546 +436 1 4.67442 2.64884 7.36908 -6.67424 -36.8328 0.644107 +437 1 6.68154 1.59605 7.24042 -18.9747 -1.14386 -19.0037 +438 1 7.52504 2.47849 6.70825 -1.30537 -8.16455 -5.2397 +439 1 7.60687 1.7083 7.61907 22.0172 -9.53549 -2.5479 +440 1 6.29708 2.66318 7.23348 12.1765 11.0009 -15.9537 +441 1 0.116615 3.32613 6.70965 -8.35482 -2.36763 -31.1169 +442 1 0.754871 4.30259 6.64315 -6.49201 3.33528 -9.76479 +443 1 0.673999 3.30917 7.54182 21.55 -11.008 11.6004 +444 1 8.2904 4.07274 7.4316 9.5379 25.3171 7.28976 +445 1 1.3832 3.4915 6.68441 -1.24784 -22.5622 2.29536 +446 1 2.09272 4.19927 6.89939 7.14914 10.3433 -0.646722 +447 1 2.38812 3.48925 7.75082 -1.53849 -4.15299 -0.56146 +448 1 0.98545 4.31304 7.66307 5.8465 7.34467 12.6645 +449 1 3.01955 3.30623 6.95327 13.2113 8.86686 7.49164 +450 1 4.09943 3.91395 7.09298 -2.48303 5.76893 1.33505 +451 1 4.01094 3.20608 7.89765 -2.70921 2.34384 1.12391 +452 1 3.37728 4.06259 7.97546 3.1883 6.31048 -16.9835 +453 1 4.95274 4.06193 6.44472 -50.262 -12.0969 -14.4258 +454 1 5.82886 4.19415 6.78586 51.8922 14.3443 21.8961 +455 1 5.38346 3.34165 7.34475 16.015 22.8896 8.36611 +456 1 5.08561 4.4601 7.63447 17.0994 -9.93497 -11.4722 +457 1 6.63523 3.51978 6.68288 11.156 -6.22589 -13.2585 +458 1 7.56324 4.26511 6.59456 -1.25309 2.63878 0.745103 +459 1 7.65852 3.28844 7.34661 -10.7372 -4.25374 3.64969 +460 1 6.81691 4.07739 7.53042 5.20496 31.087 -1.8792 +461 1 0.0305913 5.07954 6.63961 -13.4152 -0.334577 -15.0347 +462 1 0.755373 5.9128 6.63716 6.29428 -4.8245 9.83099 +463 1 0.228688 5.17338 7.63443 6.77209 -15.3569 2.77515 +464 1 0.0239769 6.1789 7.50959 5.71025 13.0173 8.45368 +465 1 1.62736 5.16876 6.26262 -1.95267 15.3222 16.2267 +466 1 2.58882 5.57631 6.81228 -21.3734 15.7914 -12.1527 +467 1 2.44828 4.86387 7.63128 0.635145 -14.9061 -0.714387 +468 1 1.59901 5.57209 7.51534 -11.1496 -3.28487 -5.03165 +469 1 3.34619 4.96263 7.08932 17.4571 -30.3367 -0.525226 +470 1 4.2543 5.71212 7.1129 9.72931 3.13017 -7.54215 +471 1 4.20945 4.90695 7.86069 -23.7666 -21.5851 -7.20856 +472 1 3.30097 5.87496 7.52978 -1.62077 18.6793 20.7743 +473 1 5.31869 5.1825 6.70313 -6.70115 -5.30598 20.424 +474 1 6.1285 5.9705 7.04356 -55.8752 -30.7828 -22.045 +475 1 6.19989 5.01385 7.64593 -24.2843 -27.8512 -0.0723503 +476 1 5.23737 5.71302 7.75618 7.88564 -2.82129 -5.95862 +477 1 6.57282 5.00818 6.64579 3.73801 7.56977 2.57742 +478 1 7.65968 6.07456 6.846 -10.6673 -6.72159 -16.2973 +479 1 7.41458 5.08419 7.34751 2.79575 -2.58892 1.26995 +480 1 6.72257 5.83109 7.80136 50.7146 16.6992 29.5346 +481 1 0.0723308 6.76891 6.47705 11.6111 8.10298 22.8191 +482 1 1.02933 7.74537 6.50218 -6.26193 -3.88943 1.15511 +483 1 0.947055 6.70337 7.58592 -5.51835 -14.0139 4.24362 +484 1 0.0848928 7.36532 7.45176 -1.87156 3.22591 1.0451 +485 1 1.56902 6.60766 6.76327 -14.013 -31.9293 15.0177 +486 1 2.40361 7.17234 6.95829 30.5527 12.991 8.35655 +487 1 2.29885 6.36291 7.58786 1.80834 5.53646 4.44151 +488 1 1.553 7.54602 7.43994 -8.27629 2.11355 -7.51923 +489 1 3.47111 6.73135 6.78593 -6.0772 1.66346 11.0677 +490 1 4.24975 7.49747 6.97664 2.8759 -9.15152 10.7243 +491 1 4.10179 6.68273 7.72108 -3.71491 1.8557 -11.1514 +492 1 3.18945 7.41445 7.81539 11.7129 -34.8369 22.2868 +493 1 5.09069 6.56162 6.92242 0.709322 1.72009 4.70344 +494 1 6.15914 7.53992 6.80488 -4.25562 -6.4834 8.29409 +495 1 6.17817 6.79535 7.72789 -19.4606 -0.130997 -26.8387 +496 1 5.10104 7.47088 7.65047 -2.76834 -2.47532 -11.4779 +497 1 6.74018 6.65599 6.74814 32.1985 25.9827 -14.7809 +498 1 7.41102 7.54832 6.72723 12.7336 -14.2037 26.5422 +499 1 7.28837 6.72521 7.66327 11.2322 2.95469 4.78999 +500 1 6.81386 7.67069 7.84231 -16.9841 5.08288 -4.95949 diff --git a/examples/mdi/dump.17Jun22.snapshot.driver.plugin.1 b/examples/mdi/dump.17Jun22.snapshot.driver.plugin.1 new file mode 100644 index 0000000000..c4ee904680 --- /dev/null +++ b/examples/mdi/dump.17Jun22.snapshot.driver.plugin.1 @@ -0,0 +1,2036 @@ +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +500 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +ITEM: ATOMS id type x y z f_2[1] f_2[2] f_2[3] +1 1 0 0 0 -1.06581e-14 -1.06581e-14 -1.00753e-14 +2 1 0.839798 0.839798 0 2.66454e-15 3.34455e-15 -9.76996e-15 +3 1 0.839798 0 0.839798 2.66454e-15 -1.05471e-14 4.56579e-15 +4 1 0 0.839798 0.839798 -1.15463e-14 2.88658e-15 3.44169e-15 +5 1 1.6796 0 0 -4.09395e-16 -9.76996e-15 -1.04361e-14 +6 1 2.51939 0.839798 0 -4.23273e-16 2.66454e-15 -1.06581e-14 +7 1 2.51939 0 0.839798 -7.00828e-16 -1.06581e-14 2.9976e-15 +8 1 1.6796 0.839798 0.839798 -4.3715e-16 3.10862e-15 3.1225e-15 +9 1 3.35919 0 0 1.28439e-14 -1.06581e-14 -1.04361e-14 +10 1 4.19899 0.839798 0 -2.25236e-14 2.66454e-15 -7.99361e-15 +11 1 4.19899 0 0.839798 -2.34118e-14 -8.88178e-15 2.55351e-15 +12 1 3.35919 0.839798 0.839798 1.37182e-14 3.10862e-15 4.23273e-15 +13 1 5.03879 0 0 2.77556e-17 -7.99361e-15 -7.99361e-15 +14 1 5.87859 0.839798 0 2.26555e-14 2.66454e-15 -7.99361e-15 +15 1 5.87859 0 0.839798 2.16702e-14 -7.99361e-15 2.66454e-15 +16 1 5.03879 0.839798 0.839798 -4.09395e-16 2.88658e-15 2.90046e-15 +17 1 6.71838 0 0 -3.33067e-15 -9.63118e-15 -9.74221e-15 +18 1 7.55818 0.839798 0 4.44089e-16 2.55351e-15 -9.32587e-15 +19 1 7.55818 0 0.839798 0 -1.02141e-14 3.21965e-15 +20 1 6.71838 0.839798 0.839798 -2.94209e-15 2.90046e-15 4.02456e-15 +21 1 0 1.6796 0 -1.15463e-14 0 -1.04361e-14 +22 1 0.839798 2.51939 0 2.88658e-15 -2.77556e-17 -9.76996e-15 +23 1 0.839798 1.6796 0.839798 2.33147e-15 2.22045e-16 3.34455e-15 +24 1 0 2.51939 0.839798 -1.06581e-14 -7.21645e-16 2.9976e-15 +25 1 1.6796 1.6796 0 -5.06539e-16 6.245e-17 -9.76996e-15 +26 1 2.51939 2.51939 0 -2.11636e-15 -1.72778e-15 -9.76996e-15 +27 1 2.51939 1.6796 0.839798 -1.2837e-15 9.08995e-16 2.88658e-15 +28 1 1.6796 2.51939 0.839798 3.53884e-16 -2.0331e-15 2.88658e-15 +29 1 3.35919 1.6796 0 1.34545e-14 3.46945e-17 -7.99361e-15 +30 1 4.19899 2.51939 0 -2.30926e-14 -1.85268e-15 -7.99361e-15 +31 1 4.19899 1.6796 0.839798 -2.24404e-14 -2.08167e-16 3.33067e-15 +32 1 3.35919 2.51939 0.839798 1.45925e-14 -1.36002e-15 3.33067e-15 +33 1 5.03879 1.6796 0 2.01228e-16 1.66533e-16 -7.10543e-15 +34 1 5.87859 2.51939 0 2.12677e-14 -1.74166e-15 -7.99361e-15 +35 1 5.87859 1.6796 0.839798 1.98383e-14 1.17961e-15 3.10862e-15 +36 1 5.03879 2.51939 0.839798 3.40006e-16 -2.80331e-15 2.88658e-15 +37 1 6.71838 1.6796 0 -3.10862e-15 -1.66533e-16 -8.10463e-15 +38 1 7.55818 2.51939 0 8.88178e-16 -1.33227e-15 -9.32587e-15 +39 1 7.55818 1.6796 0.839798 -8.04912e-16 1.94289e-16 3.33067e-15 +40 1 6.71838 2.51939 0.839798 -3.10862e-15 -1.66533e-15 3.56659e-15 +41 1 0 3.35919 0 -1.06581e-14 1.28786e-14 -9.54792e-15 +42 1 0.839798 4.19899 0 2.66454e-15 -2.24404e-14 -8.88178e-15 +43 1 0.839798 3.35919 0.839798 2.33147e-15 1.43774e-14 4.01068e-15 +44 1 0 4.19899 0.839798 -8.88178e-15 -2.32037e-14 2.55351e-15 +45 1 1.6796 3.35919 0 -8.53484e-16 1.47174e-14 -9.76996e-15 +46 1 2.51939 4.19899 0 -1.79717e-15 -2.32175e-14 -7.10543e-15 +47 1 2.51939 3.35919 0.839798 -5.06539e-16 1.51476e-14 3.55271e-15 +48 1 1.6796 4.19899 0.839798 -2.08167e-16 -2.40918e-14 3.33067e-15 +49 1 3.35919 3.35919 0 1.2608e-14 1.419e-14 -7.99361e-15 +50 1 4.19899 4.19899 0 -2.28706e-14 -2.25653e-14 -5.32907e-15 +51 1 4.19899 3.35919 0.839798 -2.21004e-14 1.13937e-14 2.88658e-15 +52 1 3.35919 4.19899 0.839798 1.249e-14 -2.21975e-14 2.88658e-15 +53 1 5.03879 3.35919 0 -2.22045e-16 1.14422e-14 -6.21725e-15 +54 1 5.87859 4.19899 0 2.22322e-14 -2.22461e-14 -5.32907e-15 +55 1 5.87859 3.35919 0.839798 2.14412e-14 1.27467e-14 2.88658e-15 +56 1 5.03879 4.19899 0.839798 -2.08167e-16 -2.11983e-14 3.10862e-15 +57 1 6.71838 3.35919 0 -3.60822e-15 1.32949e-14 -8.04912e-15 +58 1 7.55818 4.19899 0 8.88178e-16 -2.44249e-14 -7.10543e-15 +59 1 7.55818 3.35919 0.839798 1.66533e-16 1.40443e-14 3.10862e-15 +60 1 6.71838 4.19899 0.839798 -3.05311e-15 -2.40641e-14 2.45637e-15 +61 1 0 5.03879 0 -7.10543e-15 6.66134e-16 -7.32747e-15 +62 1 0.839798 5.87859 0 2.66454e-15 2.28706e-14 -7.10543e-15 +63 1 0.839798 5.03879 0.839798 2.55351e-15 -2.77556e-16 2.67841e-15 +64 1 0 5.87859 0.839798 -9.76996e-15 2.18159e-14 2.66454e-15 +65 1 1.6796 5.03879 0 8.32667e-17 -9.92262e-16 -6.21725e-15 +66 1 2.51939 5.87859 0 -2.08167e-15 2.16008e-14 -7.10543e-15 +67 1 2.51939 5.03879 0.839798 -1.72085e-15 3.81639e-16 3.10862e-15 +68 1 1.6796 5.87859 0.839798 -8.74301e-16 2.02824e-14 3.10862e-15 +69 1 3.35919 5.03879 0 1.08871e-14 -1.80411e-16 -6.21725e-15 +70 1 4.19899 5.87859 0 -2.27804e-14 2.17187e-14 -4.44089e-15 +71 1 4.19899 5.03879 0.839798 -1.95469e-14 -1.15186e-15 2.88658e-15 +72 1 3.35919 5.87859 0.839798 1.19973e-14 2.21143e-14 2.88658e-15 +73 1 5.03879 5.03879 0 1.17961e-16 6.8695e-16 -3.55271e-15 +74 1 5.87859 5.87859 0 2.17604e-14 2.22114e-14 -5.32907e-15 +75 1 5.87859 5.03879 0.839798 1.9415e-14 3.747e-16 2.88658e-15 +76 1 5.03879 5.87859 0.839798 -6.52256e-16 1.92069e-14 2.88658e-15 +77 1 6.71838 5.03879 0 -2.38698e-15 4.64906e-16 -6.43929e-15 +78 1 7.55818 5.87859 0 0 2.26485e-14 -7.54952e-15 +79 1 7.55818 5.03879 0.839798 1.11022e-16 1.44329e-15 2.498e-15 +80 1 6.71838 5.87859 0.839798 -2.94209e-15 2.15661e-14 2.45637e-15 +81 1 0 6.71838 0 -1.06581e-14 -3.77476e-15 -9.60343e-15 +82 1 0.839798 7.55818 0 2.44249e-15 7.91034e-16 -1.00892e-14 +83 1 0.839798 6.71838 0.839798 2.33147e-15 -2.83107e-15 3.80251e-15 +84 1 0 7.55818 0.839798 -8.88178e-15 -2.22045e-16 3.05311e-15 +85 1 1.6796 6.71838 0 -8.04912e-16 -1.72085e-15 -8.99281e-15 +86 1 2.51939 7.55818 0 -1.51268e-15 6.66134e-16 -9.54792e-15 +87 1 2.51939 6.71838 0.839798 -7.91034e-16 -2.83801e-15 3.56659e-15 +88 1 1.6796 7.55818 0.839798 2.08167e-16 2.77556e-16 3.33067e-15 +89 1 3.35919 6.71838 0 1.24623e-14 -2.22045e-15 -8.04912e-15 +90 1 4.19899 7.55818 0 -2.45221e-14 0 -7.99361e-15 +91 1 4.19899 6.71838 0.839798 -2.33563e-14 -4.89886e-15 2.45637e-15 +92 1 3.35919 7.55818 0.839798 1.30868e-14 8.88178e-16 2.88658e-15 +93 1 5.03879 6.71838 0 -4.02456e-16 -2.83107e-15 -6.43929e-15 +94 1 5.87859 7.55818 0 2.33563e-14 8.88178e-16 -7.10543e-15 +95 1 5.87859 6.71838 0.839798 2.1913e-14 -1.74166e-15 2.45637e-15 +96 1 5.03879 7.55818 0.839798 -2.08167e-16 -5.27356e-16 2.498e-15 +97 1 6.71838 6.71838 0 -2.83107e-15 -3.42781e-15 -7.10543e-15 +98 1 7.55818 7.55818 0 4.44089e-16 0 -8.88178e-15 +99 1 7.55818 6.71838 0.839798 5.55112e-17 -3.10862e-15 2.55351e-15 +100 1 6.71838 7.55818 0.839798 -2.88658e-15 5.27356e-16 2.56739e-15 +101 1 0 0 1.6796 -1.15463e-14 -1.04361e-14 -1.11022e-15 +102 1 0.839798 0.839798 1.6796 2.44249e-15 2.56739e-15 6.66134e-16 +103 1 0.839798 0 2.51939 2.66454e-15 -1.05471e-14 1.80411e-16 +104 1 0 0.839798 2.51939 -1.15463e-14 2.9976e-15 3.88578e-16 +105 1 1.6796 0 1.6796 1.73472e-16 -9.76996e-15 0 +106 1 2.51939 0.839798 1.6796 -1.71391e-15 2.66454e-15 3.88578e-16 +107 1 2.51939 0 2.51939 -1.6584e-15 -1.06581e-14 -1.4988e-15 +108 1 1.6796 0.839798 2.51939 2.63678e-16 3.10862e-15 -1.67227e-15 +109 1 3.35919 0 1.6796 1.41623e-14 -8.88178e-15 6.66134e-16 +110 1 4.19899 0.839798 1.6796 -2.18159e-14 2.44249e-15 -6.10623e-16 +111 1 4.19899 0 2.51939 -2.30371e-14 -7.99361e-15 -1.66533e-15 +112 1 3.35919 0.839798 2.51939 1.4419e-14 2.88658e-15 -1.90126e-15 +113 1 5.03879 0 1.6796 8.67362e-16 -8.88178e-15 8.88178e-16 +114 1 5.87859 0.839798 1.6796 2.02685e-14 2.44249e-15 1.02696e-15 +115 1 5.87859 0 2.51939 2.01159e-14 -8.88178e-15 -1.38778e-15 +116 1 5.03879 0.839798 2.51939 2.91434e-16 3.10862e-15 -1.45023e-15 +117 1 6.71838 0 1.6796 -2.52576e-15 -8.77076e-15 -9.02056e-17 +118 1 7.55818 0.839798 1.6796 3.747e-16 2.16493e-15 1.04083e-16 +119 1 7.55818 0 2.51939 1.33227e-15 -9.76996e-15 -1.9984e-15 +120 1 6.71838 0.839798 2.51939 -3.10862e-15 2.90046e-15 -2.10942e-15 +121 1 0 1.6796 1.6796 -1.28786e-14 8.88178e-16 6.66134e-16 +122 1 0.839798 2.51939 1.6796 2.33147e-15 -1.43635e-15 1.11022e-16 +123 1 0.839798 1.6796 2.51939 2.66454e-15 7.35523e-16 -1.30451e-15 +124 1 0 2.51939 2.51939 -1.06581e-14 -7.49401e-16 -1.44329e-15 +125 1 1.6796 1.6796 1.6796 2.22045e-16 -1.67921e-15 5.96745e-16 +126 1 2.51939 2.51939 1.6796 -8.95117e-16 -2.39392e-15 -1.3739e-15 +127 1 2.51939 1.6796 2.51939 -9.22873e-16 1.38778e-17 -1.17267e-15 +128 1 1.6796 2.51939 2.51939 1.38778e-16 -1.26982e-15 -2.16493e-15 +129 1 3.35919 1.6796 1.6796 1.44329e-14 -1.58207e-15 5.27356e-16 +130 1 4.19899 2.51939 1.6796 -2.17534e-14 -1.89432e-15 -4.85723e-16 +131 1 4.19899 1.6796 2.51939 -2.2024e-14 4.64906e-16 -2.11636e-15 +132 1 3.35919 2.51939 2.51939 1.47937e-14 -1.33227e-15 -2.23432e-15 +133 1 5.03879 1.6796 1.6796 6.38378e-16 -4.78784e-16 8.46545e-16 +134 1 5.87859 2.51939 1.6796 2.05322e-14 -1.4086e-15 2.28983e-16 +135 1 5.87859 1.6796 2.51939 2.02546e-14 -2.56739e-16 -2.07473e-15 +136 1 5.03879 2.51939 2.51939 5.82867e-16 -1.91513e-15 -2.16493e-15 +137 1 6.71838 1.6796 1.6796 -2.16493e-15 -9.4369e-16 5.55112e-17 +138 1 7.55818 2.51939 1.6796 -4.44089e-16 -1.11022e-15 -2.77556e-17 +139 1 7.55818 1.6796 2.51939 4.44089e-16 -6.93889e-18 -2.22045e-15 +140 1 6.71838 2.51939 2.51939 -3.27516e-15 -1.67921e-15 -2.38698e-15 +141 1 0 3.35919 1.6796 -1.11022e-14 1.39888e-14 -2.22045e-16 +142 1 0.839798 4.19899 1.6796 2.44249e-15 -2.1684e-14 -6.10623e-16 +143 1 0.839798 3.35919 2.51939 2.44249e-15 1.49047e-14 -1.83187e-15 +144 1 0 4.19899 2.51939 -8.88178e-15 -2.22322e-14 -1.60982e-15 +145 1 1.6796 3.35919 1.6796 2.08167e-16 1.37251e-14 5.41234e-16 +146 1 2.51939 4.19899 1.6796 -1.72778e-15 -2.28081e-14 -1.32533e-15 +147 1 2.51939 3.35919 2.51939 -9.92262e-16 1.42247e-14 -1.29757e-15 +148 1 1.6796 4.19899 2.51939 6.93889e-18 -2.16632e-14 -2.92821e-15 +149 1 3.35919 3.35919 1.6796 1.39194e-14 1.31006e-14 3.46945e-16 +150 1 4.19899 4.19899 1.6796 -2.1684e-14 -2.2142e-14 -1.26982e-15 +151 1 4.19899 3.35919 2.51939 -2.27457e-14 1.10675e-14 -2.81025e-15 +152 1 3.35919 4.19899 2.51939 1.17337e-14 -2.23849e-14 -3.15026e-15 +153 1 5.03879 3.35919 1.6796 -6.93889e-18 1.12688e-14 1.38778e-16 +154 1 5.87859 4.19899 1.6796 2.0213e-14 -2.25167e-14 2.28983e-16 +155 1 5.87859 3.35919 2.51939 2.08236e-14 1.21292e-14 -2.5327e-15 +156 1 5.03879 4.19899 2.51939 1.38778e-17 -1.97481e-14 -3.59435e-15 +157 1 6.71838 3.35919 1.6796 -2.96291e-15 1.29619e-14 -1.11716e-15 +158 1 7.55818 4.19899 1.6796 2.22045e-16 -2.33147e-14 -4.996e-16 +159 1 7.55818 3.35919 2.51939 1.33227e-15 1.33227e-14 -2.66454e-15 +160 1 6.71838 4.19899 2.51939 -3.27516e-15 -2.33147e-14 -2.84495e-15 +161 1 0 5.03879 1.6796 -7.10543e-15 4.44089e-16 0 +162 1 0.839798 5.87859 1.6796 2.44249e-15 2.08375e-14 7.21645e-16 +163 1 0.839798 5.03879 2.51939 2.88658e-15 2.63678e-16 -1.13798e-15 +164 1 0 5.87859 2.51939 -7.99361e-15 2.03171e-14 -1.44329e-15 +165 1 1.6796 5.03879 1.6796 2.56739e-16 8.60423e-16 8.04912e-16 +166 1 2.51939 5.87859 1.6796 -9.64506e-16 2.08375e-14 -7.35523e-16 +167 1 2.51939 5.03879 2.51939 -2.04003e-15 -4.57967e-16 -2.84495e-16 +168 1 1.6796 5.87859 2.51939 6.93889e-18 2.03101e-14 -7.91034e-16 +169 1 3.35919 5.03879 1.6796 1.12549e-14 2.08167e-17 1.08247e-15 +170 1 4.19899 5.87859 1.6796 -2.15591e-14 2.06987e-14 9.57567e-16 +171 1 4.19899 5.03879 2.51939 -1.96579e-14 4.30211e-16 -2.72699e-15 +172 1 3.35919 5.87859 2.51939 1.23929e-14 2.06432e-14 -2.2482e-15 +173 1 5.03879 5.03879 1.6796 2.77556e-17 -1.38778e-16 1.20737e-15 +174 1 5.87859 5.87859 1.6796 2.07542e-14 2.02408e-14 7.70217e-16 +175 1 5.87859 5.03879 2.51939 1.86587e-14 6.52256e-16 -1.7833e-15 +176 1 5.03879 5.87859 2.51939 -2.08167e-16 1.92762e-14 -1.33227e-15 +177 1 6.71838 5.03879 1.6796 -2.42167e-15 -1.31839e-16 -3.33067e-16 +178 1 7.55818 5.87859 1.6796 -2.22045e-16 2.19824e-14 2.22045e-16 +179 1 7.55818 5.03879 2.51939 -4.44089e-16 1.22125e-15 -1.9984e-15 +180 1 6.71838 5.87859 2.51939 -3.10862e-15 2.20657e-14 -2.19269e-15 +181 1 0 6.71838 1.6796 -1.02141e-14 -2.88658e-15 -6.66134e-16 +182 1 0.839798 7.55818 1.6796 1.9984e-15 6.38378e-16 2.22045e-16 +183 1 0.839798 6.71838 2.51939 2.66454e-15 -3.10862e-15 -2.08167e-15 +184 1 0 7.55818 2.51939 -9.76996e-15 4.44089e-16 -1.88738e-15 +185 1 1.6796 6.71838 1.6796 1.94289e-16 -2.31759e-15 1.249e-16 +186 1 2.51939 7.55818 1.6796 -1.249e-15 -6.17562e-16 5.55112e-17 +187 1 2.51939 6.71838 2.51939 -1.19349e-15 -3.10862e-15 -2.08167e-15 +188 1 1.6796 7.55818 2.51939 -2.22045e-16 1.33227e-15 -2.66454e-15 +189 1 3.35919 6.71838 1.6796 1.34198e-14 -2.02616e-15 -6.245e-17 +190 1 4.19899 7.55818 1.6796 -2.38282e-14 -4.71845e-16 1.45717e-16 +191 1 4.19899 6.71838 2.51939 -2.43278e-14 -4.60743e-15 -3.88578e-15 +192 1 3.35919 7.55818 2.51939 1.29896e-14 1.9984e-15 -2.22045e-15 +193 1 5.03879 6.71838 1.6796 -6.245e-17 -1.65146e-15 2.35922e-16 +194 1 5.87859 7.55818 1.6796 2.23294e-14 1.13798e-15 -6.93889e-18 +195 1 5.87859 6.71838 2.51939 2.15869e-14 -2.9976e-15 -2.63678e-15 +196 1 5.03879 7.55818 2.51939 -2.22045e-16 -2.22045e-16 -1.77636e-15 +197 1 6.71838 6.71838 1.6796 -2.62984e-15 -2.59515e-15 -1.47798e-15 +198 1 7.55818 7.55818 1.6796 4.44089e-16 2.22045e-16 -8.32667e-17 +199 1 7.55818 6.71838 2.51939 8.88178e-16 -2.27596e-15 -2.66454e-15 +200 1 6.71838 7.55818 2.51939 -2.9976e-15 7.91034e-16 -1.91513e-15 +201 1 0 0 3.35919 -1.06581e-14 -1.04361e-14 1.35447e-14 +202 1 0.839798 0.839798 3.35919 2.66454e-15 2.67841e-15 1.50435e-14 +203 1 0.839798 0 4.19899 2.66454e-15 -8.77076e-15 -2.26139e-14 +204 1 0 0.839798 4.19899 -8.88178e-15 2.88658e-15 -2.24265e-14 +205 1 1.6796 0 3.35919 1.73472e-16 -8.88178e-15 1.42109e-14 +206 1 2.51939 0.839798 3.35919 -1.83881e-15 2.77556e-15 1.55431e-14 +207 1 2.51939 0 4.19899 -1.67227e-15 -7.99361e-15 -2.32037e-14 +208 1 1.6796 0.839798 4.19899 -1.8735e-16 3.33067e-15 -2.28637e-14 +209 1 3.35919 0 3.35919 1.37182e-14 -7.99361e-15 1.44329e-14 +210 1 4.19899 0.839798 3.35919 -2.30232e-14 2.66454e-15 1.19071e-14 +211 1 4.19899 0 4.19899 -2.27665e-14 -5.32907e-15 -2.27041e-14 +212 1 3.35919 0.839798 4.19899 1.24276e-14 2.88658e-15 -2.27457e-14 +213 1 5.03879 0 3.35919 -2.08167e-17 -7.99361e-15 1.11022e-14 +214 1 5.87859 0.839798 3.35919 2.2489e-14 2.55351e-15 1.36002e-14 +215 1 5.87859 0 4.19899 2.21143e-14 -5.32907e-15 -2.24265e-14 +216 1 5.03879 0.839798 4.19899 -1.08941e-15 3.55271e-15 -2.22461e-14 +217 1 6.71838 0 3.35919 -2.47025e-15 -8.77076e-15 1.29619e-14 +218 1 7.55818 0.839798 3.35919 -1.11022e-15 2.60902e-15 1.4766e-14 +219 1 7.55818 0 4.19899 1.33227e-15 -6.43929e-15 -2.4647e-14 +220 1 6.71838 0.839798 4.19899 -2.38698e-15 2.67841e-15 -2.39531e-14 +221 1 0 1.6796 3.35919 -1.11022e-14 -2.22045e-16 1.44329e-14 +222 1 0.839798 2.51939 3.35919 2.77556e-15 -4.64906e-16 1.52378e-14 +223 1 0.839798 1.6796 4.19899 2.88658e-15 2.498e-16 -2.32592e-14 +224 1 0 2.51939 4.19899 -8.88178e-15 -1.60982e-15 -2.32592e-14 +225 1 1.6796 1.6796 3.35919 2.22045e-16 -7.91034e-16 1.5779e-14 +226 1 2.51939 2.51939 3.35919 -1.4086e-15 -1.02002e-15 1.46133e-14 +227 1 2.51939 1.6796 4.19899 -1.39472e-15 3.95517e-16 -2.30857e-14 +228 1 1.6796 2.51939 4.19899 -8.67362e-16 -1.45023e-15 -2.42237e-14 +229 1 3.35919 1.6796 3.35919 1.39888e-14 -2.77556e-17 1.57235e-14 +230 1 4.19899 2.51939 3.35919 -2.32939e-14 -1.64452e-15 1.24276e-14 +231 1 4.19899 1.6796 4.19899 -2.19755e-14 -9.08995e-16 -2.30302e-14 +232 1 3.35919 2.51939 4.19899 1.17822e-14 -2.00534e-15 -2.40433e-14 +233 1 5.03879 1.6796 3.35919 -2.498e-16 -9.22873e-16 1.29757e-14 +234 1 5.87859 2.51939 3.35919 2.13649e-14 -8.67362e-16 1.27398e-14 +235 1 5.87859 1.6796 4.19899 2.08236e-14 -7.42462e-16 -2.31828e-14 +236 1 5.03879 2.51939 4.19899 -4.30211e-16 -1.67227e-15 -2.22253e-14 +237 1 6.71838 1.6796 3.35919 -3.19883e-15 -4.996e-16 1.39264e-14 +238 1 7.55818 2.51939 3.35919 -4.44089e-16 -1.9984e-15 1.24345e-14 +239 1 7.55818 1.6796 4.19899 -4.44089e-16 -5.06539e-16 -2.39808e-14 +240 1 6.71838 2.51939 4.19899 -2.44249e-15 -1.47105e-15 -2.40641e-14 +241 1 0 3.35919 3.35919 -1.11022e-14 1.33227e-14 1.31006e-14 +242 1 0.839798 4.19899 3.35919 2.66454e-15 -2.26555e-14 1.12133e-14 +243 1 0.839798 3.35919 4.19899 2.44249e-15 1.28925e-14 -2.26208e-14 +244 1 0 4.19899 4.19899 -6.21725e-15 -2.26485e-14 -2.26485e-14 +245 1 1.6796 3.35919 3.35919 2.08167e-16 1.3281e-14 1.52794e-14 +246 1 2.51939 4.19899 3.35919 -2.17187e-15 -2.33494e-14 1.22957e-14 +247 1 2.51939 3.35919 4.19899 -1.94983e-15 1.21569e-14 -2.20726e-14 +248 1 1.6796 4.19899 4.19899 -5.20417e-16 -2.2489e-14 -2.38767e-14 +249 1 3.35919 3.35919 3.35919 1.28092e-14 1.24345e-14 1.42109e-14 +250 1 4.19899 4.19899 3.35919 -2.29677e-14 -2.35575e-14 8.33361e-15 +251 1 4.19899 3.35919 4.19899 -2.33702e-14 9.08301e-15 -2.33355e-14 +252 1 3.35919 4.19899 4.19899 9.67976e-15 -2.36547e-14 -2.46539e-14 +253 1 5.03879 3.35919 3.35919 -2.28983e-16 1.06026e-14 1.14353e-14 +254 1 5.87859 4.19899 3.35919 2.19408e-14 -2.21698e-14 8.51402e-15 +255 1 5.87859 3.35919 4.19899 2.15522e-14 1.01238e-14 -2.328e-14 +256 1 5.03879 4.19899 4.19899 -5.20417e-16 -2.11775e-14 -2.23085e-14 +257 1 6.71838 3.35919 3.35919 -3.1225e-15 1.22957e-14 1.31978e-14 +258 1 7.55818 4.19899 3.35919 -1.11022e-15 -2.4647e-14 1.05471e-14 +259 1 7.55818 3.35919 4.19899 -8.88178e-16 1.113e-14 -2.53131e-14 +260 1 6.71838 4.19899 4.19899 -3.60822e-15 -2.5091e-14 -2.32731e-14 +261 1 0 5.03879 3.35919 -7.10543e-15 -2.22045e-16 1.15463e-14 +262 1 0.839798 5.87859 3.35919 2.55351e-15 2.28359e-14 1.37113e-14 +263 1 0.839798 5.03879 4.19899 2.88658e-15 -1.05471e-15 -2.20102e-14 +264 1 0 5.87859 4.19899 -5.32907e-15 2.21212e-14 -2.25375e-14 +265 1 1.6796 5.03879 3.35919 2.56739e-16 -2.498e-16 1.26843e-14 +266 1 2.51939 5.87859 3.35919 -1.31145e-15 2.16702e-14 1.30659e-14 +267 1 2.51939 5.03879 4.19899 -2.06085e-15 8.04912e-16 -2.10873e-14 +268 1 1.6796 5.87859 4.19899 -7.63278e-17 2.17118e-14 -2.12261e-14 +269 1 3.35919 5.03879 3.35919 1.10328e-14 -2.01228e-16 1.11994e-14 +270 1 4.19899 5.87859 3.35919 -2.29886e-14 2.15314e-14 1.08039e-14 +271 1 4.19899 5.03879 4.19899 -2.02338e-14 -4.92661e-16 -2.14065e-14 +272 1 3.35919 5.87859 4.19899 1.03459e-14 2.19963e-14 -2.39878e-14 +273 1 5.03879 5.03879 3.35919 -1.94289e-16 -8.04912e-16 8.64586e-15 +274 1 5.87859 5.87859 3.35919 2.18645e-14 2.20171e-14 1.02141e-14 +275 1 5.87859 5.03879 4.19899 1.98036e-14 1.38778e-16 -2.15869e-14 +276 1 5.03879 5.87859 4.19899 -3.05311e-16 1.94428e-14 -2.04628e-14 +277 1 6.71838 5.03879 3.35919 -2.35922e-15 -3.53884e-16 1.02071e-14 +278 1 7.55818 5.87859 3.35919 -8.88178e-16 2.28706e-14 1.02141e-14 +279 1 7.55818 5.03879 4.19899 -1.33227e-15 -3.05311e-16 -2.33147e-14 +280 1 6.71838 5.87859 4.19899 -3.27516e-15 2.23987e-14 -2.53547e-14 +281 1 0 6.71838 3.35919 -9.32587e-15 -3.77476e-15 1.31006e-14 +282 1 0.839798 7.55818 3.35919 2.33147e-15 1.13798e-15 1.40166e-14 +283 1 0.839798 6.71838 4.19899 2.66454e-15 -2.44249e-15 -2.37865e-14 +284 1 0 7.55818 4.19899 -6.21725e-15 -2.22045e-16 -2.50355e-14 +285 1 1.6796 6.71838 3.35919 1.94289e-16 -2.25514e-15 1.4419e-14 +286 1 2.51939 7.55818 3.35919 -1.59595e-15 -6.10623e-16 1.37668e-14 +287 1 2.51939 6.71838 4.19899 -8.95117e-16 -2.55351e-15 -2.28983e-14 +288 1 1.6796 7.55818 4.19899 -5.13478e-16 8.88178e-16 -2.44249e-14 +289 1 3.35919 6.71838 3.35919 1.20876e-14 -2.85189e-15 1.31353e-14 +290 1 4.19899 7.55818 3.35919 -2.47094e-14 -9.4369e-16 1.06026e-14 +291 1 4.19899 6.71838 4.19899 -2.41057e-14 -3.77476e-15 -2.26208e-14 +292 1 3.35919 7.55818 4.19899 1.06998e-14 1.55431e-15 -2.53131e-14 +293 1 5.03879 6.71838 3.35919 -6.245e-17 -3.36536e-15 1.00892e-14 +294 1 5.87859 7.55818 3.35919 2.328e-14 4.44089e-16 1.02696e-14 +295 1 5.87859 6.71838 4.19899 2.31135e-14 -3.33067e-15 -2.39531e-14 +296 1 5.03879 7.55818 4.19899 -6.93889e-17 2.22045e-16 -2.28706e-14 +297 1 6.71838 6.71838 3.35919 -2.63678e-15 -2.97679e-15 1.21014e-14 +298 1 7.55818 7.55818 3.35919 -4.44089e-16 2.22045e-16 1.2268e-14 +299 1 7.55818 6.71838 4.19899 0 -2.94209e-15 -2.70894e-14 +300 1 6.71838 7.55818 4.19899 -3.10862e-15 9.57567e-16 -2.65621e-14 +301 1 0 0 5.03879 -7.99361e-15 -7.77156e-15 6.66134e-16 +302 1 0.839798 0.839798 5.03879 2.44249e-15 2.56739e-15 2.22045e-16 +303 1 0.839798 0 5.87859 2.88658e-15 -7.88258e-15 2.30926e-14 +304 1 0 0.839798 5.87859 -8.88178e-15 2.88658e-15 2.23155e-14 +305 1 1.6796 0 5.03879 -3.67761e-16 -8.88178e-15 -6.66134e-16 +306 1 2.51939 0.839798 5.03879 -1.26982e-15 2.66454e-15 8.60423e-16 +307 1 2.51939 0 5.87859 -2.08167e-15 -7.99361e-15 2.15383e-14 +308 1 1.6796 0.839798 5.87859 2.63678e-16 2.88658e-15 2.07612e-14 +309 1 3.35919 0 5.03879 1.09704e-14 -7.10543e-15 1.11022e-15 +310 1 4.19899 0.839798 5.03879 -2.02546e-14 2.66454e-15 -4.996e-16 +311 1 4.19899 0 5.87859 -2.26694e-14 -5.32907e-15 2.09832e-14 +312 1 3.35919 0.839798 5.87859 1.21708e-14 2.88658e-15 2.16979e-14 +313 1 5.03879 0 5.03879 -3.1225e-16 -5.32907e-15 2.22045e-16 +314 1 5.87859 0.839798 5.03879 1.91652e-14 2.77556e-15 1.9984e-15 +315 1 5.87859 0 5.87859 2.18436e-14 -4.44089e-15 2.27041e-14 +316 1 5.03879 0.839798 5.87859 -3.747e-16 3.10862e-15 2.10387e-14 +317 1 6.71838 0 5.03879 -3.30291e-15 -5.27356e-15 8.32667e-17 +318 1 7.55818 0.839798 5.03879 -1.11022e-16 2.41474e-15 1.66533e-15 +319 1 7.55818 0 5.87859 8.88178e-16 -7.32747e-15 2.33147e-14 +320 1 6.71838 0.839798 5.87859 -2.27596e-15 2.67841e-15 2.30926e-14 +321 1 0 1.6796 5.03879 -7.99361e-15 -6.66134e-16 2.22045e-16 +322 1 0.839798 2.51939 5.03879 2.44249e-15 -1.1588e-15 5.82867e-16 +323 1 0.839798 1.6796 5.87859 2.66454e-15 7.35523e-16 2.19269e-14 +324 1 0 2.51939 5.87859 -7.99361e-15 -1.83187e-15 2.15938e-14 +325 1 1.6796 1.6796 5.03879 2.01228e-16 -5.27356e-16 1.97065e-15 +326 1 2.51939 2.51939 5.03879 -1.00614e-15 -1.22818e-15 4.16334e-17 +327 1 2.51939 1.6796 5.87859 -9.99201e-16 -1.38778e-17 2.22808e-14 +328 1 1.6796 2.51939 5.87859 1.52656e-16 -1.38778e-15 2.04003e-14 +329 1 3.35919 1.6796 5.03879 1.17545e-14 2.63678e-16 1.02696e-15 +330 1 4.19899 2.51939 5.03879 -2.02893e-14 -2.11636e-15 -4.30211e-16 +331 1 4.19899 1.6796 5.87859 -2.20032e-14 -9.02056e-16 2.10318e-14 +332 1 3.35919 2.51939 5.87859 1.25316e-14 -1.51962e-15 2.06363e-14 +333 1 5.03879 1.6796 5.03879 8.88178e-16 -5.6205e-16 2.7478e-15 +334 1 5.87859 2.51939 5.03879 1.8846e-14 -7.84095e-16 1.20737e-15 +335 1 5.87859 1.6796 5.87859 2.0664e-14 -1.14492e-15 2.01852e-14 +336 1 5.03879 2.51939 5.87859 3.60822e-16 -1.94289e-15 1.76248e-14 +337 1 6.71838 1.6796 5.03879 -3.08781e-15 -8.74301e-16 5.96745e-16 +338 1 7.55818 2.51939 5.03879 -2.22045e-16 -1.55431e-15 2.22045e-16 +339 1 7.55818 1.6796 5.87859 1.77636e-15 -9.08995e-16 2.19824e-14 +340 1 6.71838 2.51939 5.87859 -2.60902e-15 -1.94289e-15 2.10665e-14 +341 1 0 3.35919 5.03879 -8.88178e-15 1.06581e-14 4.44089e-16 +342 1 0.839798 4.19899 5.03879 2.77556e-15 -2.00534e-14 -9.71445e-16 +343 1 0.839798 3.35919 5.87859 2.66454e-15 1.26565e-14 2.26763e-14 +344 1 0 4.19899 5.87859 -7.10543e-15 -2.27318e-14 2.12053e-14 +345 1 1.6796 3.35919 5.03879 2.15106e-16 1.11022e-14 1.249e-15 +346 1 2.51939 4.19899 5.03879 -1.61676e-15 -2.07542e-14 8.32667e-17 +347 1 2.51939 3.35919 5.87859 -1.34615e-15 1.1921e-14 2.25445e-14 +348 1 1.6796 4.19899 5.87859 -8.74301e-16 -2.1684e-14 1.93387e-14 +349 1 3.35919 3.35919 5.03879 1.08247e-14 1.05055e-14 6.245e-16 +350 1 4.19899 4.19899 5.03879 -2.08722e-14 -2.192e-14 5.55112e-16 +351 1 4.19899 3.35919 5.87859 -2.34326e-14 9.83241e-15 2.01436e-14 +352 1 3.35919 4.19899 5.87859 9.61037e-15 -2.29053e-14 2.15591e-14 +353 1 5.03879 3.35919 5.03879 6.31439e-16 6.7446e-15 5.41234e-16 +354 1 5.87859 4.19899 5.03879 1.91375e-14 -2.03101e-14 2.498e-16 +355 1 5.87859 3.35919 5.87859 2.14412e-14 1.00198e-14 2.06293e-14 +356 1 5.03879 4.19899 5.87859 -2.01228e-16 -2.06224e-14 1.59386e-14 +357 1 6.71838 3.35919 5.03879 -3.02536e-15 9.69363e-15 4.85723e-17 +358 1 7.55818 4.19899 5.03879 -8.88178e-16 -2.28706e-14 -3.33067e-16 +359 1 7.55818 3.35919 5.87859 4.44089e-16 1.11855e-14 2.30926e-14 +360 1 6.71838 4.19899 5.87859 -3.44169e-15 -2.34396e-14 2.11914e-14 +361 1 0 5.03879 5.03879 -3.9968e-15 -6.66134e-16 4.44089e-16 +362 1 0.839798 5.87859 5.03879 2.66454e-15 1.93595e-14 5.55112e-16 +363 1 0.839798 5.03879 5.87859 3.10862e-15 -4.02456e-16 2.03726e-14 +364 1 0 5.87859 5.87859 -5.32907e-15 2.18159e-14 2.27596e-14 +365 1 1.6796 5.03879 5.03879 2.77556e-17 4.16334e-17 1.3739e-15 +366 1 2.51939 5.87859 5.03879 -1.56125e-15 1.82285e-14 1.76248e-15 +367 1 2.51939 5.03879 5.87859 -2.04003e-15 -1.1241e-15 1.95052e-14 +368 1 1.6796 5.87859 5.87859 2.08167e-17 2.11636e-14 2.05252e-14 +369 1 3.35919 5.03879 5.03879 8.17402e-15 3.40006e-16 3.33067e-16 +370 1 4.19899 5.87859 5.03879 -2.08653e-14 1.81868e-14 3.26128e-16 +371 1 4.19899 5.03879 5.87859 -2.05391e-14 -2.28983e-16 1.85199e-14 +372 1 3.35919 5.87859 5.87859 1.02834e-14 2.14967e-14 2.09693e-14 +373 1 5.03879 5.03879 5.03879 2.35922e-16 2.498e-16 -1.30451e-15 +374 1 5.87859 5.87859 5.03879 1.90889e-14 1.87003e-14 -2.70617e-16 +375 1 5.87859 5.03879 5.87859 1.91305e-14 8.74301e-16 1.98105e-14 +376 1 5.03879 5.87859 5.87859 1.38778e-17 1.92832e-14 1.88183e-14 +377 1 6.71838 5.03879 5.03879 -3.45557e-15 -3.05311e-16 1.51962e-15 +378 1 7.55818 5.87859 5.03879 -4.44089e-16 2.08722e-14 1.66533e-16 +379 1 7.55818 5.03879 5.87859 -1.33227e-15 5.55112e-16 2.08722e-14 +380 1 6.71838 5.87859 5.87859 -3.33067e-15 2.20102e-14 2.08999e-14 +381 1 0 6.71838 5.03879 -7.54952e-15 -4.44089e-15 8.88178e-16 +382 1 0.839798 7.55818 5.03879 2.33147e-15 4.71845e-16 9.15934e-16 +383 1 0.839798 6.71838 5.87859 2.88658e-15 -2.27596e-15 2.23016e-14 +384 1 0 7.55818 5.87859 -6.21725e-15 -2.22045e-16 2.31482e-14 +385 1 1.6796 6.71838 5.03879 -1.38778e-17 -2.86576e-15 1.27676e-15 +386 1 2.51939 7.55818 5.03879 -1.51268e-15 -8.32667e-16 6.66134e-16 +387 1 2.51939 6.71838 5.87859 -1.32533e-15 -2.27596e-15 2.22322e-14 +388 1 1.6796 7.55818 5.87859 -2.498e-16 1.77636e-15 2.13163e-14 +389 1 3.35919 6.71838 5.03879 1.05402e-14 -3.47639e-15 2.19963e-15 +390 1 4.19899 7.55818 5.03879 -2.27665e-14 -1.44329e-15 8.32667e-16 +391 1 4.19899 6.71838 5.87859 -2.39184e-14 -2.94209e-15 2.11775e-14 +392 1 3.35919 7.55818 5.87859 1.08802e-14 1.55431e-15 2.28706e-14 +393 1 5.03879 6.71838 5.03879 -7.63278e-17 -4.04538e-15 1.38778e-17 +394 1 5.87859 7.55818 5.03879 2.10457e-14 -7.21645e-16 7.21645e-16 +395 1 5.87859 6.71838 5.87859 2.31065e-14 -3.10862e-15 2.18714e-14 +396 1 5.03879 7.55818 5.87859 1.38778e-17 -4.44089e-16 2.08722e-14 +397 1 6.71838 6.71838 5.03879 -2.76168e-15 -2.74086e-15 -3.88578e-16 +398 1 7.55818 7.55818 5.03879 0 0 -6.66134e-16 +399 1 7.55818 6.71838 5.87859 0 -2.94209e-15 2.39808e-14 +400 1 6.71838 7.55818 5.87859 -3.16414e-15 7.77156e-16 2.42029e-14 +401 1 0 0 6.71838 -1.06581e-14 -1.04361e-14 -3.77476e-15 +402 1 0.839798 0.839798 6.71838 2.66454e-15 2.67841e-15 -2.72005e-15 +403 1 0.839798 0 7.55818 2.55351e-15 -9.70057e-15 1.05471e-15 +404 1 0 0.839798 7.55818 -8.88178e-15 2.66454e-15 4.44089e-16 +405 1 1.6796 0 6.71838 2.08167e-16 -7.99361e-15 -2.44249e-15 +406 1 2.51939 0.839798 6.71838 -1.8735e-15 2.77556e-15 -2.72005e-15 +407 1 2.51939 0 7.55818 -1.56819e-15 -8.88178e-15 0 +408 1 1.6796 0.839798 7.55818 -1.11022e-16 2.66454e-15 1.55431e-15 +409 1 3.35919 0 6.71838 1.26288e-14 -7.10543e-15 -2.88658e-15 +410 1 4.19899 0.839798 6.71838 -2.40641e-14 2.66454e-15 -4.69069e-15 +411 1 4.19899 0 7.55818 -2.43069e-14 -7.99361e-15 -4.44089e-16 +412 1 3.35919 0.839798 7.55818 1.38223e-14 2.66454e-15 1.33227e-15 +413 1 5.03879 0 6.71838 2.22045e-16 -6.21725e-15 -3.10862e-15 +414 1 5.87859 0.839798 6.71838 2.22183e-14 2.55351e-15 -1.4988e-15 +415 1 5.87859 0 7.55818 2.35922e-14 -6.21725e-15 -8.88178e-16 +416 1 5.03879 0.839798 7.55818 -4.71845e-16 2.55351e-15 -2.77556e-17 +417 1 6.71838 0 6.71838 -3.38618e-15 -6.99441e-15 -3.94129e-15 +418 1 7.55818 0.839798 6.71838 -1.16573e-15 2.60902e-15 -3.10862e-15 +419 1 7.55818 0 7.55818 -4.44089e-16 -8.65974e-15 -8.88178e-16 +420 1 6.71838 0.839798 7.55818 -2.27596e-15 2.45637e-15 0 +421 1 0 1.6796 6.71838 -1.02141e-14 -4.44089e-16 -3.33067e-15 +422 1 0.839798 2.51939 6.71838 2.77556e-15 -4.996e-16 -3.05311e-15 +423 1 0.839798 1.6796 7.55818 2.66454e-15 1.11022e-16 -1.66533e-16 +424 1 0 2.51939 7.55818 -7.99361e-15 -1.76248e-15 -2.22045e-16 +425 1 1.6796 1.6796 6.71838 2.08167e-16 -7.63278e-16 -2.31759e-15 +426 1 2.51939 2.51939 6.71838 -1.38778e-15 -9.99201e-16 -2.73392e-15 +427 1 2.51939 1.6796 7.55818 -1.47105e-15 5.55112e-17 7.14706e-16 +428 1 1.6796 2.51939 7.55818 -3.33067e-16 -2.06779e-15 -1.45717e-16 +429 1 3.35919 1.6796 6.71838 1.30312e-14 -6.93889e-18 -2.52576e-15 +430 1 4.19899 2.51939 6.71838 -2.37796e-14 -2.35922e-15 -4.35069e-15 +431 1 4.19899 1.6796 7.55818 -2.36061e-14 4.64906e-16 -6.45317e-16 +432 1 3.35919 2.51939 7.55818 1.29549e-14 -8.60423e-16 -1.20043e-15 +433 1 5.03879 1.6796 6.71838 0 -5.68989e-16 -2.42861e-15 +434 1 5.87859 2.51939 6.71838 2.20657e-14 -1.10328e-15 -2.7478e-15 +435 1 5.87859 1.6796 7.55818 2.22045e-14 -6.245e-16 5.20417e-16 +436 1 5.03879 2.51939 7.55818 1.38778e-16 -1.83187e-15 -8.46545e-16 +437 1 6.71838 1.6796 6.71838 -2.32453e-15 -5.06539e-16 -2.59515e-15 +438 1 7.55818 2.51939 6.71838 -2.22045e-16 -1.9984e-15 -3.4972e-15 +439 1 7.55818 1.6796 7.55818 6.66134e-16 5.55112e-17 -1.33227e-15 +440 1 6.71838 2.51939 7.55818 -2.83107e-15 -2.06779e-15 -6.66134e-16 +441 1 0 3.35919 6.71838 -1.11022e-14 1.31006e-14 -2.88658e-15 +442 1 0.839798 4.19899 6.71838 2.66454e-15 -2.28359e-14 -4.46865e-15 +443 1 0.839798 3.35919 7.55818 2.55351e-15 1.38362e-14 5.55112e-17 +444 1 0 4.19899 7.55818 -7.99361e-15 -2.44457e-14 -8.88178e-16 +445 1 1.6796 3.35919 6.71838 2.22045e-16 1.20598e-14 -2.05391e-15 +446 1 2.51939 4.19899 6.71838 -1.09635e-15 -2.38767e-14 -4.46171e-15 +447 1 2.51939 3.35919 7.55818 -1.92901e-15 1.40235e-14 -9.02056e-17 +448 1 1.6796 4.19899 7.55818 4.16334e-17 -2.43833e-14 -1.54737e-15 +449 1 3.35919 3.35919 6.71838 1.28716e-14 1.13104e-14 -2.16493e-15 +450 1 4.19899 4.19899 6.71838 -2.44943e-14 -2.37588e-14 -4.78784e-15 +451 1 4.19899 3.35919 7.55818 -2.42584e-14 1.09426e-14 6.38378e-16 +452 1 3.35919 4.19899 7.55818 1.13798e-14 -2.49245e-14 -1.59595e-15 +453 1 5.03879 3.35919 6.71838 -2.35922e-16 8.98587e-15 -1.98452e-15 +454 1 5.87859 4.19899 6.71838 2.29469e-14 -2.33771e-14 -3.1572e-15 +455 1 5.87859 3.35919 7.55818 2.34951e-14 1.07414e-14 1.80411e-15 +456 1 5.03879 4.19899 7.55818 4.16334e-17 -2.19547e-14 -1.42941e-15 +457 1 6.71838 3.35919 6.71838 -3.13638e-15 1.12688e-14 -2.26208e-15 +458 1 7.55818 4.19899 6.71838 2.22045e-16 -2.59792e-14 -1.38778e-15 +459 1 7.55818 3.35919 7.55818 0 1.28855e-14 -8.88178e-16 +460 1 6.71838 4.19899 7.55818 -2.66454e-15 -2.52992e-14 -1.05471e-15 +461 1 0 5.03879 6.71838 -6.21725e-15 2.22045e-16 -2.22045e-15 +462 1 0.839798 5.87859 6.71838 2.55351e-15 2.25375e-14 -2.38698e-15 +463 1 0.839798 5.03879 7.55818 2.66454e-15 1.38778e-17 6.38378e-16 +464 1 0 5.87859 7.55818 -6.21725e-15 2.3842e-14 -2.22045e-16 +465 1 1.6796 5.03879 6.71838 4.44089e-16 -1.17961e-15 -2.20657e-15 +466 1 2.51939 5.87859 6.71838 -1.51962e-15 2.23849e-14 -2.19269e-15 +467 1 2.51939 5.03879 7.55818 -1.90126e-15 -3.26128e-16 6.38378e-16 +468 1 1.6796 5.87859 7.55818 -6.93889e-17 2.2593e-14 1.76942e-15 +469 1 3.35919 5.03879 6.71838 1.02557e-14 -1.31839e-15 -2.20657e-15 +470 1 4.19899 5.87859 6.71838 -2.37102e-14 2.16563e-14 -1.60288e-15 +471 1 4.19899 5.03879 7.55818 -2.25375e-14 1.38778e-17 -7.63278e-16 +472 1 3.35919 5.87859 7.55818 1.15047e-14 2.3162e-14 8.32667e-16 +473 1 5.03879 5.03879 6.71838 -2.28983e-16 -1.00614e-15 -3.27516e-15 +474 1 5.87859 5.87859 6.71838 2.35922e-14 2.19824e-14 -1.88738e-15 +475 1 5.87859 5.03879 7.55818 2.15383e-14 -2.63678e-16 7.70217e-16 +476 1 5.03879 5.87859 7.55818 1.38778e-17 2.13718e-14 3.26128e-16 +477 1 6.71838 5.03879 6.71838 -3.48332e-15 -9.71445e-16 -1.83187e-15 +478 1 7.55818 5.87859 6.71838 -2.22045e-16 2.39808e-14 -3.38618e-15 +479 1 7.55818 5.03879 7.55818 -1.33227e-15 -1.17961e-16 -6.66134e-16 +480 1 6.71838 5.87859 7.55818 -2.83107e-15 2.47372e-14 -3.88578e-16 +481 1 0 6.71838 6.71838 -9.32587e-15 -3.9968e-15 -2.88658e-15 +482 1 0.839798 7.55818 6.71838 2.44249e-15 0 -2.94209e-15 +483 1 0.839798 6.71838 7.55818 2.55351e-15 -3.15026e-15 -3.33067e-16 +484 1 0 7.55818 7.55818 -8.88178e-15 0 -2.22045e-16 +485 1 1.6796 6.71838 6.71838 2.15106e-16 -3.04617e-15 -3.05311e-15 +486 1 2.51939 7.55818 6.71838 -1.54043e-15 -5.55112e-16 -2.72005e-15 +487 1 2.51939 6.71838 7.55818 -2.08167e-15 -2.55351e-15 -2.77556e-17 +488 1 1.6796 7.55818 7.55818 2.77556e-17 -6.66134e-16 -1.11022e-15 +489 1 3.35919 6.71838 6.71838 1.22749e-14 -3.60129e-15 -2.27596e-15 +490 1 4.19899 7.55818 6.71838 -2.57433e-14 -6.66134e-16 -3.27516e-15 +491 1 4.19899 6.71838 7.55818 -2.58682e-14 -3.55271e-15 4.44089e-16 +492 1 3.35919 7.55818 7.55818 1.25316e-14 0 -4.44089e-16 +493 1 5.03879 6.71838 6.71838 0 -4.14252e-15 -3.19189e-15 +494 1 5.87859 7.55818 6.71838 2.47719e-14 -4.996e-16 -2.66454e-15 +495 1 5.87859 6.71838 7.55818 2.47163e-14 -2.66454e-15 -5.55112e-17 +496 1 5.03879 7.55818 7.55818 5.55112e-17 -2.22045e-16 6.66134e-16 +497 1 6.71838 6.71838 6.71838 -2.58127e-15 -3.18495e-15 -3.03924e-15 +498 1 7.55818 7.55818 6.71838 -2.22045e-16 0 -3.05311e-15 +499 1 7.55818 6.71838 7.55818 0 -2.69229e-15 -1.33227e-15 +500 1 6.71838 7.55818 7.55818 -2.66454e-15 9.02056e-16 -2.22045e-16 +ITEM: TIMESTEP +100 +ITEM: NUMBER OF ATOMS +500 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +ITEM: ATOMS id type x y z f_2[1] f_2[2] f_2[3] +1 1 0.123071 8.38872 8.3161 -13.5034 12.7208 4.27264 +2 1 0.832093 0.789482 0.0260634 11.6405 -9.02308 5.27054 +3 1 0.829348 8.32295 0.847054 0.253685 2.42198 0.190462 +4 1 0.167866 0.883683 1.1203 3.78838 -17.5987 -23.5446 +5 1 1.84325 0.268983 0.0506746 -34.1939 -23.1747 -16.5239 +6 1 2.48966 1.02521 0.0150167 17.3336 21.4777 -8.17686 +7 1 2.69085 0.133161 0.584204 54.6376 -37.2919 -8.47938 +8 1 2.03129 0.673907 1.00581 -42.9604 37.8091 32.6152 +9 1 3.4644 0.135395 8.22513 6.66121 1.25052 1.24977 +10 1 4.03955 1.11148 8.14659 12.0412 -8.97859 6.48992 +11 1 4.19379 0.0448744 0.829139 -7.8302 -27.8417 -6.76025 +12 1 3.64841 0.913699 0.700293 -19.72 -1.80986 -1.25088 +13 1 4.95468 8.24864 0.0754237 1.84477 -0.530278 -6.08608 +14 1 5.56087 0.715896 7.89459 8.56765 -1.46102 11.0915 +15 1 5.88623 0.0411411 0.556827 1.26181 -8.5789 -11.0866 +16 1 4.92937 0.724638 0.812217 17.273 10.8714 -8.85433 +17 1 6.72739 8.38085 8.13417 -35.3805 -5.9515 28.6252 +18 1 7.72548 0.788736 0.0488514 2.00593 -21.6326 -29.6842 +19 1 7.72508 8.25409 0.930095 1.50566 4.42937 -3.62071 +20 1 6.80396 0.557293 0.840198 23.1381 -17.3706 0.134541 +21 1 0.229449 1.60533 8.39298 -14.4977 16.7962 1.07689 +22 1 0.832071 2.6454 0.0244343 3.40253 -11.2938 10.3532 +23 1 1.17502 1.54184 1.17348 -25.8959 -2.9461 -24.9151 +24 1 0.259004 2.30396 1.08005 -0.921709 -4.92947 -4.61717 +25 1 1.52612 1.69846 0.0790119 2.24081 -1.66091 4.11232 +26 1 2.32335 2.59169 0.0356063 -1.33192 -7.27448 11.4357 +27 1 2.47613 1.68798 0.866847 -6.11708 -1.09078 12.1273 +28 1 1.75964 2.46963 1.02161 -10.4242 6.62214 -9.26339 +29 1 3.18899 1.91192 0.152422 12.8306 -10.0239 -26.2805 +30 1 4.16606 2.56561 0.31819 6.19268 17.1047 -29.5908 +31 1 4.20679 1.77492 0.904599 6.39419 -20.2587 16.143 +32 1 3.29457 2.54016 0.942536 8.4707 7.62624 9.38928 +33 1 5.08962 1.70142 0.228194 -1.96985 -10.7878 -18.1781 +34 1 5.8401 2.50153 8.17919 2.2116 -4.35098 8.5453 +35 1 6.13077 1.14332 0.361455 -13.4767 12.4455 -5.6398 +36 1 5.21187 2.29543 1.04708 -21.2445 17.0192 -2.44157 +37 1 7.1904 2.12537 8.11861 -26.262 1.63538 -8.89421 +38 1 7.82272 2.3769 0.452291 6.46918 9.92036 10.2415 +39 1 7.65568 1.36632 0.837818 -8.61574 34.9087 15.0511 +40 1 6.63096 2.29607 0.833592 -3.02945 -9.31899 -38.2195 +41 1 0.0701224 3.26957 0.347776 -7.76983 -4.00147 -12.0182 +42 1 0.634247 4.2146 8.13102 5.69069 28.6823 19.9973 +43 1 0.89062 3.25892 1.01274 -8.90571 5.17288 9.1951 +44 1 8.35578 4.21333 0.756755 0.0651816 10.3427 6.16366 +45 1 1.59376 3.50824 0.337522 12.8481 -18.5931 -31.178 +46 1 2.63362 4.08805 -0.0117409 -13.6881 -31.4545 31.8377 +47 1 2.64545 3.44217 0.972182 1.32962 4.76915 -6.91838 +48 1 1.77157 4.31331 0.893182 6.24463 15.8362 30.2465 +49 1 3.30506 3.15734 -0.00281637 -4.50664 8.90697 10.0795 +50 1 4.20121 3.98351 8.24532 14.9588 -4.89636 4.16185 +51 1 4.14049 3.34001 1.03567 7.31744 -35.2634 -0.734077 +52 1 3.55633 4.09497 0.714486 -22.5487 2.59697 3.44603 +53 1 5.00488 3.2958 8.40544 4.72004 -3.7586 -0.0676635 +54 1 6.02419 4.38739 8.28472 2.63675 -3.85348 -7.36203 +55 1 5.82125 3.13701 0.812331 3.285 1.60137 -0.83853 +56 1 4.81191 4.1205 0.886429 26.0514 -19.7571 -10.6482 +57 1 6.37904 3.38462 8.29958 8.77859 5.40588 1.21659 +58 1 7.16155 4.27433 8.23885 -4.15514 -15.8519 20.8515 +59 1 7.46381 3.5222 0.62725 -6.50801 1.62892 11.1525 +60 1 6.52496 4.16064 0.796816 7.21171 -6.93074 -7.48151 +61 1 8.21062 5.02405 8.32529 2.06274 -1.43255 -7.09188 +62 1 0.856242 5.68027 8.15143 -7.33544 -9.25849 21.6195 +63 1 0.668812 5.05722 1.0253 10.4106 -11.6037 -16.0599 +64 1 0.100757 5.9519 0.987463 -8.02818 6.7945 -7.41084 +65 1 1.67634 4.74298 8.35528 -7.26839 1.52359 -11.0387 +66 1 2.38848 5.51086 0.107164 2.54651 6.03927 1.46743 +67 1 2.70757 4.93813 1.01132 -4.75577 -9.71554 1.13089 +68 1 1.3925 5.83052 0.707681 -1.14437 -6.44566 7.34655 +69 1 3.45574 4.66587 8.23291 4.73605 39.4767 5.5614 +70 1 4.43743 5.80479 0.164115 -6.64024 0.386075 1.78009 +71 1 4.2065 4.90669 0.741814 -23.5797 23.1046 -22.8102 +72 1 3.32112 5.74269 0.715517 7.3169 4.77905 3.84994 +73 1 5.16076 4.9557 8.31038 -10.6163 5.08193 1.86037 +74 1 5.94307 5.96922 0.174598 0.307423 -9.87615 -0.075099 +75 1 5.67998 4.99641 0.866467 -3.37502 0.387608 -1.06988 +76 1 5.10533 6.15466 0.974945 -0.684733 -17.9465 -18.2172 +77 1 6.66954 5.212 0.215572 3.55269 -19.7927 -9.30717 +78 1 7.63194 6.03007 0.0625005 22.452 -11.4487 -13.3981 +79 1 7.77987 5.15692 0.880268 -13.4303 3.64316 1.97115 +80 1 6.9443 6.00859 0.774386 -22.1564 -21.0173 44.3085 +81 1 0.211543 6.60981 0.114883 -6.22763 -3.96979 4.85396 +82 1 0.828363 7.71074 8.05758 6.57912 -12.175 1.18202 +83 1 0.8511 6.85772 1.00145 14.3344 -16.9148 6.86093 +84 1 0.108182 7.491 0.729711 -16.3275 13.3125 -2.16192 +85 1 1.32651 6.53754 8.31267 17.3977 32.295 0.779922 +86 1 2.45313 7.32438 0.161863 4.38219 8.94585 -15.0057 +87 1 2.22206 6.5101 0.817864 2.61276 2.64125 -0.96007 +88 1 1.71157 7.54558 0.836721 -10.8648 3.37169 8.49449 +89 1 3.33137 6.74361 0.251121 4.01956 -5.07144 -3.19134 +90 1 4.31785 7.3164 0.250439 -2.62105 14.0423 -19.3334 +91 1 4.11403 6.69271 1.01148 -3.23605 5.58393 9.21791 +92 1 3.25046 7.65301 0.863299 7.69366 -3.67127 3.31805 +93 1 5.15822 6.61638 8.39412 -15.5898 18.5262 -4.77657 +94 1 5.88176 7.47131 8.35911 1.25772 40.9097 -41.218 +95 1 5.8589 6.89406 0.716878 17.4729 -36.9167 60.1945 +96 1 5.1317 7.5805 0.887324 -15.4398 8.72154 0.622041 +97 1 6.7242 6.72984 0.126171 2.95649 13.978 -28.6002 +98 1 7.71076 7.70275 8.27387 -25.252 1.96163 47.723 +99 1 7.67756 6.66145 0.969756 13.165 19.6736 4.48693 +100 1 6.86126 7.61056 0.694229 -2.98636 3.99324 3.02821 +101 1 8.36607 8.27958 1.86716 -0.17632 -3.19355 -10.789 +102 1 0.956051 0.693329 1.82901 -1.1092 0.489919 9.03263 +103 1 0.677954 8.19357 2.69404 9.64796 -1.44576 4.92708 +104 1 8.40822 0.658358 2.57043 0.358989 35.1247 -30.1625 +105 1 1.59709 8.27384 1.6579 -3.48424 8.95256 3.83776 +106 1 2.60262 0.937274 1.91114 -6.85695 -44.4167 -8.16487 +107 1 2.77964 8.33738 2.42411 -9.97653 17.8509 12.2111 +108 1 1.80103 0.545423 2.70436 3.05773 -0.374817 -3.43865 +109 1 3.48439 0.0645578 1.59153 -12.2456 1.16104 1.511 +110 1 4.22306 0.908637 1.62246 8.21176 3.032 -1.28199 +111 1 4.10829 0.251535 2.42791 -11.6297 -7.60593 -5.50766 +112 1 3.3006 0.854758 2.76304 -19.992 -17.3193 -31.4497 +113 1 4.89013 8.37666 1.691 47.9119 57.0599 0.585594 +114 1 5.94061 0.477826 1.48406 -3.07899 1.88699 12.3275 +115 1 5.88048 0.35971 2.56281 -4.35157 -20.3865 4.17854 +116 1 4.9283 1.00358 2.55425 0.721177 -5.70224 -8.52683 +117 1 6.83323 8.16485 1.66012 -9.63203 10.6138 -6.53177 +118 1 7.60236 0.72315 1.6205 1.19764 -13.0731 15.2148 +119 1 7.46261 8.34785 2.50942 4.27014 7.86644 3.21827 +120 1 6.98477 1.01167 2.43863 -2.7077 -3.72405 10.5475 +121 1 0.201795 1.49879 1.91201 12.0746 15.4759 7.55997 +122 1 0.970651 2.5763 1.77546 9.10281 -9.21672 19.206 +123 1 1.00278 1.70354 2.64935 -4.86832 -2.32063 -12.0578 +124 1 0.220174 2.4694 2.59226 -6.06395 2.41662 -4.31274 +125 1 1.87438 1.66139 1.85364 0.0891009 8.26815 7.54904 +126 1 2.5634 2.61259 1.66324 -1.39613 -9.56029 15.7565 +127 1 2.67373 1.74855 2.48368 16.2507 26.3662 25.5413 +128 1 1.81271 2.51993 2.48462 -12.4635 -12.9481 6.24626 +129 1 3.34642 1.5174 1.55361 6.72778 19.0825 -4.097 +130 1 4.08393 2.3973 1.7811 -4.91883 6.9472 -7.45962 +131 1 3.95017 1.57032 2.47783 9.96822 8.42852 -4.63348 +132 1 3.54843 2.54548 2.73936 0.891724 -11.4891 -8.75214 +133 1 5.35058 1.38537 1.51823 -3.50731 -2.89085 5.66595 +134 1 6.023 2.29204 1.65213 -4.43652 -0.464129 22.1024 +135 1 5.94747 1.35093 2.39209 2.54676 22.9646 2.61125 +136 1 4.92685 2.18916 2.37644 10.4243 -2.12633 1.01963 +137 1 6.61187 1.36453 1.49274 0.221959 8.29598 -0.620687 +138 1 7.32473 2.28685 1.57865 28.4734 -28.9459 -8.73783 +139 1 7.72873 1.81047 2.35176 -1.00775 -9.06934 31.0045 +140 1 6.61584 2.21437 2.52479 7.01251 0.0677084 2.80218 +141 1 8.39022 3.27891 1.73012 3.49525 -5.17929 -4.65996 +142 1 0.854964 4.19407 1.69788 1.56946 -2.00702 1.06174 +143 1 0.997978 3.23715 2.67504 2.30643 5.8223 1.06858 +144 1 7.97382 3.9138 2.48815 10.0732 9.91828 -12.5132 +145 1 1.83784 3.47408 1.69517 -12.404 -3.21409 -2.66267 +146 1 2.61842 4.21682 1.90008 2.14748 0.059531 -3.785 +147 1 2.48603 3.26502 2.5249 16.8304 14.9965 0.171158 +148 1 1.68761 4.23907 2.52806 -1.01396 -4.72261 -0.795752 +149 1 3.40602 3.2813 1.85914 -16.1626 0.355927 -8.83409 +150 1 4.09906 4.10307 1.70079 5.35563 8.08157 -4.08084 +151 1 4.20252 3.30769 2.50236 16.5461 8.94662 0.427258 +152 1 3.52577 4.20363 2.52362 -12.9682 0.481811 23.6133 +153 1 5.11847 3.18122 1.75203 -10.5302 -5.4337 -0.263304 +154 1 5.84661 3.9209 1.56262 -0.517958 8.86577 8.63788 +155 1 5.86922 3.05768 2.56393 3.07392 -0.105811 -3.05554 +156 1 4.80787 4.20147 2.51562 -15.5306 -18.6016 6.98719 +157 1 6.75594 3.06184 1.51831 -23.9843 53.9056 5.35996 +158 1 7.37411 4.33015 1.50837 10.7935 -8.89263 2.38858 +159 1 7.49772 2.90887 2.46868 -6.63254 10.1343 -14.9923 +160 1 6.70853 3.86113 2.32478 1.28299 1.19192 -0.76331 +161 1 8.35107 4.97447 1.76826 -6.01727 -4.60108 12.0065 +162 1 0.812206 5.83167 1.72433 7.83055 6.4827 17.8655 +163 1 0.780537 4.91988 2.60048 6.34607 -5.57446 -13.8552 +164 1 8.22728 5.818 2.44166 16.0462 -1.57715 15.6299 +165 1 1.69572 5.11642 1.80574 -4.96566 -14.135 -5.31489 +166 1 2.43043 5.85297 1.63568 5.29915 -1.62077 5.85546 +167 1 2.57792 5.02783 2.65315 -4.52746 -19.2236 -8.91777 +168 1 1.53526 5.79854 2.60003 3.8059 -10.2938 -9.84612 +169 1 3.51815 5.02648 1.76532 -11.6984 -21.692 -35.1665 +170 1 4.20879 5.78771 1.44267 -4.45704 -9.43328 11.2812 +171 1 4.17986 5.08228 2.52246 26.037 -4.72131 -0.0794421 +172 1 3.28564 5.71935 2.4374 15.7539 34.931 2.27384 +173 1 4.77269 4.90482 1.56605 20.4715 8.53759 27.1606 +174 1 6.0822 5.98003 1.39493 -10.1112 -7.66907 2.17662 +175 1 5.55864 4.81486 2.32198 32.4427 -4.71792 -40.0608 +176 1 5.42317 5.8389 2.32907 -1.32862 11.7729 0.869635 +177 1 6.58632 5.00994 1.4228 1.50987 11.9718 7.91199 +178 1 7.40728 5.76017 1.85143 -17.7756 -1.69935 -20.7445 +179 1 7.43483 4.90248 2.50406 4.81208 -4.17509 -3.00519 +180 1 6.49032 6.25339 2.53785 -9.86939 -13.1275 -11.226 +181 1 8.38687 6.70803 1.84686 8.51598 2.67685 -7.76441 +182 1 0.82672 7.5809 1.8586 -8.65199 -8.55201 -6.88257 +183 1 0.798368 6.66179 2.58415 -9.89719 -0.151349 -9.60426 +184 1 8.09266 7.50342 2.71078 14.8523 -0.33865 -5.72558 +185 1 1.67226 6.92941 1.90638 3.68667 -6.81729 -3.8166 +186 1 2.44977 7.72472 1.67328 13.6121 -19.3583 -10.8323 +187 1 2.6005 7.00136 2.53195 -4.75836 -8.709 1.95523 +188 1 1.74762 7.69197 2.71318 -2.53247 4.05033 -0.19863 +189 1 3.12318 6.68472 1.56494 -10.4586 3.85751 -11.4518 +190 1 4.29009 7.65387 1.60791 -51.7416 -54.1223 -14.9832 +191 1 3.94907 6.70085 2.16915 18.0446 -8.10905 7.08373 +192 1 3.47208 7.58339 2.49347 14.5465 5.92984 -2.02778 +193 1 5.12563 6.77282 1.76131 -9.48863 14.4825 6.97263 +194 1 5.83539 7.62987 1.64588 8.72191 3.82062 7.16953 +195 1 5.76423 6.96836 2.55864 -5.64345 11.6948 11.2338 +196 1 4.77822 7.71547 2.51809 6.21883 -11.3323 9.13654 +197 1 6.63559 6.81418 1.65333 9.11964 14.1494 -8.37133 +198 1 7.61434 7.47455 1.72558 2.40335 0.461228 -6.0911 +199 1 7.4792 6.66861 2.39873 -2.80551 0.930229 8.6336 +200 1 6.74988 7.49855 2.51532 0.27108 -2.11137 5.23264 +201 1 8.33028 0.11458 3.36279 -16.5826 -29.3888 39.8482 +202 1 0.924222 0.663074 3.34599 -4.22349 8.71948 1.26084 +203 1 0.761543 8.18959 3.97906 2.12091 4.50677 4.24971 +204 1 8.33433 0.813163 4.20564 6.5007 1.52148 -0.192127 +205 1 1.76574 0.0375621 3.77071 17.3013 -16.3871 -16.9245 +206 1 2.61977 0.818953 3.52119 -23.2651 -2.55324 12.2346 +207 1 2.77562 0.0652161 4.44741 -11.8421 6.13727 -13.8855 +208 1 1.49199 0.761034 4.41597 -5.10709 15.0925 14.5126 +209 1 3.2179 8.34804 3.44668 5.27936 -7.50847 -1.90568 +210 1 3.9439 0.797129 3.52456 17.3728 2.18733 11.5361 +211 1 4.23279 0.116688 4.32559 -2.42219 -2.56552 -2.26636 +212 1 3.32804 0.997948 4.36883 1.65433 -5.54648 3.47818 +213 1 4.71275 0.120112 3.21294 23.362 4.56383 23.3458 +214 1 5.81093 1.04185 3.50642 -3.03834 -26.4106 -17.8435 +215 1 5.68877 0.288558 4.20831 -1.41276 -13.7346 9.5471 +216 1 5.01865 1.1392 4.32627 0.968145 -3.23051 -6.43149 +217 1 6.64793 8.39618 3.24984 2.09632 -4.36032 3.69009 +218 1 7.5883 0.965027 3.40354 -4.44096 -3.20185 -1.58139 +219 1 7.46506 8.38162 4.26807 1.21074 2.40143 -20.8016 +220 1 6.68567 0.729309 4.05423 9.00491 -0.0257829 7.04417 +221 1 0.0217051 1.65067 3.33296 -0.896942 -12.0422 -1.44038 +222 1 0.778955 2.33585 3.53158 8.17696 34.6193 -17.2054 +223 1 0.812105 1.63712 4.22741 2.15493 -21.1842 9.58449 +224 1 8.36402 2.71734 4.23224 9.90405 -0.180735 2.89262 +225 1 1.64503 1.55583 3.44456 9.91651 -2.24847 10.5707 +226 1 2.72789 2.60115 3.33289 -22.1633 -6.4618 14.3253 +227 1 2.53285 1.75288 4.15927 -11.2604 4.59027 8.59695 +228 1 1.59486 2.51559 4.29587 -0.634079 -19.903 20.3392 +229 1 3.26158 1.6458 3.43181 16.9482 17.4067 -1.31054 +230 1 4.49124 2.67296 3.29881 0.516577 8.93567 6.85853 +231 1 4.12441 1.76399 4.16025 -12.4119 -16.9863 20.8263 +232 1 3.58648 2.62356 4.12513 -11.0948 -0.0880381 2.09248 +233 1 4.62064 1.66433 3.30411 17.3359 -14.3916 -7.7698 +234 1 5.72203 2.02067 3.4449 -2.49843 31.6335 -13.0426 +235 1 6.15135 1.60495 4.33133 -9.75959 4.02084 8.19224 +236 1 5.04088 2.23941 4.27882 30.2001 -2.39587 -19.7025 +237 1 6.91779 1.8813 3.52264 3.96777 -26.054 4.41687 +238 1 7.81771 2.53776 3.353 -2.77684 -3.41763 12.6677 +239 1 7.78069 1.81171 4.34601 -52.3825 1.07947 -51.791 +240 1 6.66141 2.49312 4.62997 -6.69802 -0.0628228 -12.7191 +241 1 0.122629 3.46604 3.3479 -1.26446 -22.7991 -11.2332 +242 1 0.85888 4.22824 3.46647 2.79502 3.87933 -3.60293 +243 1 0.937247 3.40088 4.29114 -12.1658 -1.27655 -7.25993 +244 1 8.30307 4.19021 4.02192 -7.37977 10.0618 19.4199 +245 1 1.73804 3.18337 3.5685 -15.8464 9.26468 -37.1326 +246 1 2.58615 4.05913 3.19953 0.360202 14.7294 -1.16411 +247 1 2.55925 3.4674 4.05471 16.7959 -2.51521 13.6147 +248 1 1.75131 4.20697 4.04231 3.51698 -5.56503 7.27084 +249 1 3.44857 3.37138 3.44602 9.39764 18.3315 -14.5187 +250 1 4.30487 4.37452 3.51867 -0.743412 -11.0963 -4.3924 +251 1 4.41614 3.34547 4.13696 17.6233 7.57534 -14.2893 +252 1 3.32801 4.25542 4.08286 6.07649 -1.13934 3.22429 +253 1 5.63651 3.09553 3.631 -4.7187 3.44811 6.48572 +254 1 5.99275 4.08946 3.17209 -2.06613 -3.23888 -8.73239 +255 1 6.47603 3.67609 4.18744 -9.24013 0.891239 -0.0265923 +256 1 5.32989 4.17403 4.01248 -3.14576 -0.648453 6.26049 +257 1 6.72457 2.86539 3.51605 -3.69406 17.3565 -4.96963 +258 1 7.32281 3.76777 3.25105 -10.2265 -1.63605 18.2335 +259 1 7.4303 3.25631 4.3358 5.44768 7.87627 -9.74689 +260 1 6.66407 4.65396 3.76405 -6.96361 -4.18223 2.73914 +261 1 8.26711 4.8857 3.17584 6.51218 -0.295316 -2.27808 +262 1 0.649285 5.74933 3.20979 -12.9544 -9.12523 -13.313 +263 1 1.01858 5.10915 4.40565 1.04387 0.402418 -2.70019 +264 1 0.0855082 5.80312 4.16158 -11.0199 -7.09759 8.81305 +265 1 1.78399 4.97143 3.32025 -23.7199 7.54456 -3.60592 +266 1 2.55969 5.96317 3.12483 -8.84523 11.7944 16.8138 +267 1 2.653 5.05017 3.85074 -4.37713 4.79953 16.9312 +268 1 2.04667 5.9581 4.23583 -12.9689 -9.50066 -2.67062 +269 1 3.52568 5.09169 3.32195 -1.60301 -3.74832 -0.530875 +270 1 4.17719 5.92991 3.13207 5.79449 2.84869 4.98978 +271 1 4.69237 5.20087 4.04914 -22.9168 0.480558 19.5714 +272 1 3.49623 5.87284 4.08872 -22.1914 -19.7939 -11.835 +273 1 5.22134 4.9979 3.22696 -11.435 -2.89555 -13.2152 +274 1 5.65705 6.11892 3.42751 2.78011 1.11701 -3.25891 +275 1 5.76121 5.22134 4.03501 7.67556 -2.59727 25.3068 +276 1 4.95772 6.04539 4.58052 58.0203 8.0254 -45.1554 +277 1 6.4538 5.11955 2.78748 -4.74406 7.07146 5.73728 +278 1 7.21538 5.95413 3.16364 10.7768 -10.9442 6.36207 +279 1 7.51809 5.20099 3.85697 17.9797 5.14787 9.68311 +280 1 6.63903 5.76912 4.06379 2.12496 12.0521 4.75162 +281 1 8.12324 6.45888 3.3557 6.09728 0.195353 -8.64393 +282 1 0.462088 7.19726 3.46792 19.553 -0.0547515 -15.4409 +283 1 0.957118 6.33073 3.94731 10.4711 20.6934 10.8557 +284 1 8.31788 7.62476 4.18946 -15.5996 1.5203 27.0435 +285 1 1.621 6.60508 3.20723 21.3874 20.2704 9.57573 +286 1 2.43565 7.40381 3.575 -2.23423 10.7661 -7.60718 +287 1 2.75508 6.70843 4.26783 9.69215 -9.86312 8.63304 +288 1 1.4194 7.32943 4.0782 6.712 1.12768 -13.3449 +289 1 3.55435 6.77984 3.25216 -11.0849 -3.43265 4.44657 +290 1 4.09983 7.6717 3.40332 0.775894 2.91256 6.51607 +291 1 4.08342 6.6168 4.34423 8.99422 27.9061 4.38721 +292 1 3.36001 7.55781 4.25663 44.0502 4.81661 -43.4399 +293 1 4.74991 6.77738 3.51304 4.59094 -3.55683 -10.177 +294 1 5.77556 7.6737 3.71378 -0.245399 -1.3978 -0.93703 +295 1 5.90589 6.74801 4.34426 -3.316 -4.25196 -0.216303 +296 1 4.8074 7.40991 4.34207 4.23627 19.8452 -2.32284 +297 1 6.58813 6.85169 3.45364 -7.67639 -5.27403 -11.3349 +298 1 7.50241 7.47925 3.56723 2.18816 13.5038 -24.0989 +299 1 7.40344 6.62065 4.10638 -2.8935 -4.19323 5.51308 +300 1 6.75843 7.5046 4.25149 -20.47 8.43665 16.7865 +301 1 8.33167 8.36145 4.9892 0.225809 34.2346 -31.8957 +302 1 0.576342 0.867151 5.40959 24.5697 -12.6304 -33.2572 +303 1 0.763006 0.00458111 6.00676 12.4506 6.43147 -2.11226 +304 1 8.26499 0.860176 6.08382 -7.17683 -4.07129 -51.5552 +305 1 1.81244 8.0383 4.87052 -5.76863 7.26347 -9.86755 +306 1 2.53533 1.09902 5.19234 -3.16803 0.678291 -2.97003 +307 1 2.78135 0.403413 6.40689 -26.816 9.12488 -11.3363 +308 1 1.58905 0.651353 5.66283 7.03419 0.981612 1.76622 +309 1 3.32058 0.106866 5.32447 -0.932856 13.5857 14.9154 +310 1 4.27557 0.92435 5.10725 -6.99093 5.63655 -6.45098 +311 1 4.28959 0.280237 5.95961 -30.2191 -30.0316 -14.6333 +312 1 3.38904 1.26869 5.835 20.8336 -7.28254 -13.6106 +313 1 5.00946 8.32617 5.09801 -7.438 6.03549 0.926349 +314 1 5.92216 0.863628 5.14574 -0.277075 -6.34381 -3.05305 +315 1 5.73427 0.0193827 5.90902 4.17974 0.428592 2.11829 +316 1 4.94752 0.963499 5.95092 36.9682 12.4342 8.28196 +317 1 6.68007 0.0753806 5.17719 -6.21888 -0.275929 -7.94036 +318 1 7.59475 0.718477 4.99 5.56935 4.26124 12.8688 +319 1 7.48253 8.3166 5.84711 10.9136 10.2783 15.4989 +320 1 6.8326 0.897437 5.9487 8.18452 -13.9005 5.8213 +321 1 0.0760609 1.64664 4.96296 26.1716 -2.70613 34.3225 +322 1 0.685552 2.56455 5.03633 12.0035 4.84556 -15.2829 +323 1 0.606729 1.82267 5.82598 7.27963 -3.46786 12.0617 +324 1 8.3293 2.58271 5.72712 2.9601 13.0212 32.1025 +325 1 1.39999 1.70565 5.12122 8.3487 -4.09076 2.04128 +326 1 2.73507 2.85653 4.90403 -0.345779 -0.804973 -4.73226 +327 1 2.41817 2.24309 5.70209 1.42091 -4.90412 -0.964796 +328 1 1.38108 2.54746 5.86585 12.2906 4.17611 0.525771 +329 1 3.33731 1.91289 4.90293 0.0185627 0.794978 8.4213 +330 1 4.3973 2.60866 4.92615 -15.1153 4.67891 22.5372 +331 1 4.2225 2.0218 5.81106 18.0418 -47.4422 -19.4137 +332 1 3.4994 2.65878 5.66207 -24.6152 28.1329 2.91513 +333 1 5.20081 1.64695 5.25699 -1.61968 25.0354 -10.6249 +334 1 5.90254 2.56674 5.38347 4.70787 3.18361 -12.95 +335 1 6.08989 1.61464 5.89214 -10.9271 -1.55847 2.77666 +336 1 5.02754 2.69198 5.87273 -13.869 2.1523 1.52243 +337 1 6.90208 1.46146 5.07178 -10.118 15.4867 -8.4201 +338 1 7.58477 2.54489 5.07036 0.223295 2.60985 -3.71518 +339 1 7.69807 1.70404 5.74305 2.65747 -7.01835 5.70621 +340 1 6.83671 2.31874 5.77518 8.75763 5.85965 2.81961 +341 1 8.33535 3.4475 5.0472 4.04483 5.65066 -3.26522 +342 1 0.908217 4.16423 5.06292 -2.0575 1.13184 -0.501506 +343 1 0.771491 3.42595 5.87741 5.33449 1.31478 -10.6197 +344 1 0.14652 4.33584 6.04676 1.00462 -8.1578 -20.2597 +345 1 1.77294 3.51463 4.93957 -1.27898 -7.63546 3.32247 +346 1 2.71396 3.96357 4.97834 15.9141 3.79204 10.1307 +347 1 2.46159 3.38803 6.16546 -1.0491 -20.8555 -15.9327 +348 1 1.72608 4.39112 6.04032 -15.046 -11.018 -10.0045 +349 1 3.71274 3.40467 4.85974 -22.3519 13.9348 10.8973 +350 1 4.57553 4.21697 4.87404 -3.96399 7.00234 -1.98713 +351 1 4.366 3.53193 5.70269 7.89254 -3.17347 6.37497 +352 1 3.55123 4.20329 5.82208 -22.8323 -11.992 0.86056 +353 1 5.31479 3.43328 4.96004 -12.842 -18.3451 -4.95866 +354 1 5.96487 4.21664 4.98586 3.26728 12.2832 1.14917 +355 1 5.67633 3.58987 5.96581 6.91479 -13.8012 -0.0730494 +356 1 5.15168 4.48521 5.88819 -0.135174 -6.62981 7.61527 +357 1 6.76571 3.37692 5.24691 -14.8051 -2.47074 -4.50431 +358 1 7.42413 4.19524 5.01259 2.27671 4.46784 -0.576517 +359 1 7.6092 3.42318 5.84837 11.8264 -15.8262 -18.7291 +360 1 6.54398 4.29611 5.89957 10.509 -8.9195 -1.16059 +361 1 0.0247094 4.83566 4.99938 1.36656 0.603431 -2.15766 +362 1 0.966205 6.14847 4.9405 -1.84638 -2.56131 10.6129 +363 1 1.10739 5.11215 5.5368 -2.77114 7.32267 -6.17701 +364 1 0.221311 5.77966 5.62316 -16.3542 -5.99991 -34.5248 +365 1 2.09075 4.80339 4.88071 -15.5377 1.88455 -3.51044 +366 1 2.76626 5.59872 5.00497 -13.1053 -0.333159 -40.3797 +367 1 2.60002 4.95633 5.81939 -13.3057 -3.60712 -16.1699 +368 1 1.73302 6.11974 5.67311 7.80367 -13.5214 9.39307 +369 1 3.69174 5.11983 4.8182 4.27828 -13.6521 -3.16237 +370 1 4.24517 5.95869 5.19837 -53.2876 -10.1225 40.5156 +371 1 4.22774 4.94663 5.7496 8.19104 22.5118 -1.663 +372 1 3.1136 6.02947 5.80151 37.6339 -12.4217 36.265 +373 1 5.23537 5.12533 5.07481 2.14794 5.35663 -5.58383 +374 1 5.80775 6.19434 5.36474 -12.1517 -18.4331 -19.8184 +375 1 5.9697 5.18437 6.0003 -7.47906 6.99384 0.912527 +376 1 4.94854 5.8692 5.99559 17.5377 -1.26338 -12.9619 +377 1 6.59757 5.09144 5.08104 3.06742 4.08464 -2.92894 +378 1 7.54367 5.98613 4.88573 -14.2361 -23.7654 7.79426 +379 1 7.60847 5.23322 5.63185 -1.35187 -6.94343 4.2911 +380 1 6.70769 5.94816 5.81677 14.1283 2.13907 3.81564 +381 1 8.22278 6.71702 5.01662 22.4316 17.1972 -3.51396 +382 1 0.869349 7.28869 4.96667 -10.0366 3.62496 3.89926 +383 1 0.896793 6.73687 5.91431 -6.40765 3.74255 3.0528 +384 1 0.0890555 7.7054 5.6706 -5.18167 -47.9244 34.8448 +385 1 1.8751 6.88564 4.94229 0.477268 -2.00274 -5.71819 +386 1 2.7587 7.55291 4.99872 -36.0591 6.05211 43.0833 +387 1 2.53846 6.82983 5.7787 -13.9577 26.1772 12.6196 +388 1 1.63934 7.57104 5.79621 -1.51722 -4.07644 10.4552 +389 1 3.46612 6.83867 5.20388 -3.25728 -8.15264 -25.1259 +390 1 4.01792 7.77747 5.13143 8.22604 -9.98488 -11.0207 +391 1 4.0616 6.71165 5.99374 37.4635 -34.7522 2.57336 +392 1 3.49035 7.48383 6.06615 -52.3442 43.3465 -6.60384 +393 1 4.82693 6.8523 5.20763 2.69445 10.0085 20.3981 +394 1 5.83663 7.67662 4.94011 2.65651 0.782445 -0.458959 +395 1 5.60118 6.903 6.05259 0.51238 5.45548 -5.22943 +396 1 4.49984 7.67391 6.05154 31.0401 -0.647522 -9.371 +397 1 6.56806 6.92617 5.22736 4.49918 -20.7724 -24.6194 +398 1 7.45007 7.68748 5.02454 6.13987 -21.0163 7.77973 +399 1 7.49751 6.80367 5.78308 -9.98894 13.1501 -5.7166 +400 1 6.63057 7.61754 5.92417 0.0687578 21.3795 23.8905 +401 1 8.32557 8.34894 6.68981 0.104638 -13.8897 -9.6087 +402 1 0.744366 0.980723 6.48852 -5.23114 -31.7269 30.0044 +403 1 1.21108 0.262565 7.55604 -5.48851 -4.18087 -6.76609 +404 1 8.40118 0.701811 7.40569 17.4537 3.62996 11.6339 +405 1 1.79336 8.32699 6.64062 -5.93242 0.737609 -0.84307 +406 1 2.60519 1.4776 6.42908 -42.7477 -20.3947 10.8513 +407 1 2.68468 8.32969 7.50367 2.82039 -8.74718 0.911275 +408 1 2.14004 0.776947 7.26895 -3.65906 16.1309 -1.11008 +409 1 3.6569 0.0715803 6.70451 13.9675 -20.3473 29.1568 +410 1 3.94985 1.1248 6.78323 8.0083 0.919865 -1.94163 +411 1 4.44955 0.15543 7.5921 -15.5929 3.09145 7.2634 +412 1 3.18676 1.19789 7.55079 30.4701 -36.3009 -8.08868 +413 1 5.10396 0.131358 6.81912 -7.97923 37.9971 -21.1894 +414 1 5.81993 0.996314 6.79068 7.76858 -21.7284 -2.73997 +415 1 5.80025 8.18188 7.49322 12.3507 -13.1302 8.70784 +416 1 4.85408 1.28227 7.42764 -12.4579 -6.47968 -9.5274 +417 1 6.58875 0.130914 6.74241 2.12753 -2.2097 0.634037 +418 1 7.59964 0.676617 6.71682 -68.3673 2.07925 42.2066 +419 1 7.52212 0.0593286 7.5834 32.5631 3.04014 -28.8024 +420 1 6.85279 0.923554 7.57208 -4.28539 1.49265 -2.17621 +421 1 8.34941 1.72633 6.6429 -6.24486 10.7883 12.2426 +422 1 0.752277 2.47155 6.72526 -3.9412 -10.7788 3.00465 +423 1 0.813192 1.63555 7.42993 -7.74314 -11.2011 -0.638694 +424 1 8.22443 2.54813 7.66732 2.56273 -1.56785 0.82339 +425 1 1.49636 1.56107 6.38447 44.5625 33.4582 -3.13704 +426 1 2.30525 2.475 6.76961 -5.35408 6.54562 -0.949005 +427 1 2.49056 1.84724 7.59513 -61.407 9.30511 10.8314 +428 1 1.49273 2.39823 7.65033 13.5773 11.0727 -11.0854 +429 1 3.37689 2.03992 6.64219 17.5424 18.1797 1.52712 +430 1 4.36556 2.35363 6.72974 2.65202 20.8248 17.9478 +431 1 3.99822 2.02063 7.6547 18.3091 -10.0739 6.1027 +432 1 3.17328 2.55424 7.53823 -10.8617 31.8229 -4.73645 +433 1 5.21112 1.76508 6.50479 -18.4173 6.52495 3.64931 +434 1 5.87572 2.50861 6.47972 17.6588 16.4017 11.3405 +435 1 6.13161 1.75643 7.42519 -6.35346 6.11936 8.80778 +436 1 5.08243 2.27965 7.49559 3.10695 14.763 0.591819 +437 1 6.90515 1.73737 6.69685 6.36969 -4.89015 -2.67266 +438 1 7.59965 2.63279 6.71489 9.55617 -0.301288 -8.47778 +439 1 7.76189 1.52013 7.52701 3.93719 -1.66085 -6.19761 +440 1 6.70724 2.6779 7.2598 -8.99322 4.2321 11.9078 +441 1 0.125444 3.31521 6.66881 -20.5423 -11.9528 1.08126 +442 1 0.364694 4.22273 7.06 15.4688 8.78987 -5.27721 +443 1 0.60791 3.34758 7.65433 9.81501 -30.9601 -14.2913 +444 1 8.0984 3.85412 7.73406 0.295867 21.4592 0.238003 +445 1 1.38869 3.28611 6.86269 8.50148 8.2104 -0.813622 +446 1 2.52476 4.25334 6.66316 13.9982 13.4488 20.9739 +447 1 2.34408 3.26799 7.64808 -1.14502 9.26403 -10.1755 +448 1 1.45935 4.43411 7.31503 0.0272838 -0.538431 -2.52173 +449 1 3.66593 3.34626 6.65797 -1.50742 -4.19973 -15.7128 +450 1 4.32339 4.28741 6.63848 -1.71153 0.00989822 -0.270268 +451 1 4.03917 3.1404 7.61252 24.7136 -10.2891 3.12208 +452 1 3.36907 3.93473 7.50701 -10.481 -0.383957 -6.9951 +453 1 4.88527 3.3354 6.73465 -0.250758 1.18323 3.20962 +454 1 5.86197 4.30684 6.74144 -6.02175 10.4775 -12.9313 +455 1 5.83143 3.4729 7.33725 -5.24712 -23.3614 7.27214 +456 1 5.04517 4.19893 7.47372 14.0277 -13.7659 1.86079 +457 1 6.67093 3.19494 6.32389 -1.08882 16.2366 5.3564 +458 1 7.58567 3.93824 6.68879 13.8607 17.9546 17.9945 +459 1 7.41034 3.22296 8.01852 -22.7502 -28.7124 0.282368 +460 1 6.74041 3.98357 7.25541 -1.38378 3.03134 11.4432 +461 1 8.11164 5.05821 6.64701 -10.3621 4.23498 3.48281 +462 1 0.434229 5.95598 6.55583 13.6324 -1.56553 39.6492 +463 1 0.429061 5.17903 7.41995 -0.29478 -7.71855 -15.5486 +464 1 8.09598 5.94892 7.38464 -0.670206 -2.17368 6.38869 +465 1 1.41611 5.29567 6.55129 0.191903 6.07763 6.12613 +466 1 2.44376 5.87825 6.63669 -4.18767 0.226771 1.1996 +467 1 2.57445 4.71437 7.62895 -9.06207 26.6712 -23.195 +468 1 1.76163 5.67875 7.56712 4.16416 -0.382203 -1.94173 +469 1 3.23562 5.1121 6.55719 20.8924 -0.347412 22.4145 +470 1 4.05367 5.80831 6.49809 -13.6658 -13.8236 9.34588 +471 1 4.3499 4.91428 7.57309 -17.8958 19.2373 1.53594 +472 1 3.33848 5.81136 8.0112 0.629066 -2.48199 -2.55986 +473 1 5.22933 5.24678 6.83002 -9.21161 -10.3226 -4.65561 +474 1 5.87231 6.12998 6.73434 -14.492 -21.708 -7.10976 +475 1 6.102 5.06631 7.42095 8.16162 7.57706 8.09799 +476 1 5.11386 5.85851 7.69037 1.37823 -1.01778 -7.91082 +477 1 6.94866 5.10876 6.52261 -0.00645701 0.734687 4.76591 +478 1 7.67078 6.01392 6.41167 -4.02477 -14.728 2.57416 +479 1 7.35061 4.96205 7.5433 24.0095 -18.1944 -20.4412 +480 1 6.9284 5.83495 7.63045 -18.4707 37.5628 2.3937 +481 1 8.28984 6.85999 6.50497 12.0319 11.2505 5.01489 +482 1 0.775248 7.71516 6.80461 7.24585 -11.6558 8.08417 +483 1 0.533688 6.7762 7.54365 3.89137 -4.31915 -15.8578 +484 1 8.2465 7.61079 7.46416 25.9419 0.696332 -26.8887 +485 1 1.73177 6.71435 6.78434 -8.61422 -0.737705 -7.23833 +486 1 2.48272 7.50206 6.80041 12.0152 -3.31551 -7.82219 +487 1 2.37093 6.72113 7.64339 9.62293 -9.48685 2.94166 +488 1 1.77272 7.59226 7.58949 -2.97267 7.70343 0.621675 +489 1 3.29197 6.66554 6.74519 -6.55378 -4.76021 6.1499 +490 1 4.04728 7.44441 6.9325 9.38301 -4.09453 15.5296 +491 1 4.12674 6.55075 7.78018 3.09461 4.03017 -1.80654 +492 1 3.3807 7.43243 7.7243 -9.78058 -0.600287 9.7772 +493 1 4.74428 6.55735 6.78071 12.1641 10.0813 15.0085 +494 1 5.30209 7.56833 6.75011 8.90694 -20.2013 0.20059 +495 1 5.88783 6.83008 7.50111 -3.28565 3.55282 5.18781 +496 1 4.85536 7.429 7.66393 -0.8844 -0.824359 14.1315 +497 1 6.78323 6.58213 6.75112 16.4005 10.5566 0.00129152 +498 1 7.49771 7.53891 6.69245 -0.0692693 6.11315 -11.5276 +499 1 7.61589 6.80831 7.76686 -5.70997 -4.77696 -9.529 +500 1 6.80731 7.4637 7.45575 -10.489 5.43873 12.05 +ITEM: TIMESTEP +200 +ITEM: NUMBER OF ATOMS +500 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +ITEM: ATOMS id type x y z f_2[1] f_2[2] f_2[3] +1 1 8.41242 8.26599 8.38785 -10.0358 6.58437 5.2801 +2 1 0.814162 0.710931 0.0523899 -37.3452 31.5986 3.80166 +3 1 0.707188 8.3394 0.783901 7.22527 -6.84977 10.4166 +4 1 0.078844 0.75192 1.11978 38.2878 -8.01586 -1.83777 +5 1 1.52052 0.0613493 8.33894 50.642 -18.5757 54.2409 +6 1 2.63022 0.777198 -0.0136511 -14.6872 26.2087 -8.24369 +7 1 2.86573 8.3667 0.519039 4.98442 -20.5506 12.9041 +8 1 1.4757 0.711348 0.992341 22.4024 -8.05229 -33.8354 +9 1 3.79318 8.20698 8.14977 -12.6173 11.8638 7.05406 +10 1 4.0381 1.06879 8.36154 -11.3644 -3.77089 -31.1235 +11 1 3.94622 0.00241404 0.83531 3.0713 5.57971 3.39388 +12 1 3.2904 1.19609 0.697286 11.5663 -9.90219 11.4209 +13 1 4.80931 8.28217 0.152557 1.5084 -10.3853 -19.3359 +14 1 5.59181 0.724855 8.1093 -26.5323 12.4899 -7.60558 +15 1 5.68752 0.120676 0.713607 11.3113 1.42738 1.49966 +16 1 4.78554 0.81043 0.585131 26.0655 -22.1296 9.76004 +17 1 6.43613 0.237453 8.26775 30.1844 -14.2258 6.08634 +18 1 7.5043 0.643436 0.0691857 2.69659 0.617275 -0.831401 +19 1 7.7682 0.0476766 1.0238 2.88283 -8.74262 5.4154 +20 1 6.83111 0.459822 0.931748 -10.2254 10.6222 -23.4955 +21 1 0.00401405 1.51379 8.26626 1.73444 -9.97848 2.73777 +22 1 0.631563 2.29056 0.214422 2.30445 -4.73927 -16.4851 +23 1 0.869727 1.5347 0.919411 -20.3113 -10.6479 -1.82401 +24 1 -0.0840974 2.27001 1.15035 26.4165 13.702 -18.8298 +25 1 1.67911 1.38813 0.0883733 4.29152 4.16945 3.72554 +26 1 2.34463 2.397 8.3967 -0.661743 10.3894 16.138 +27 1 2.41792 1.69378 0.837891 -11.9994 8.17272 5.13712 +28 1 1.50784 2.3296 0.8821 15.8347 5.46342 -6.24169 +29 1 3.19181 1.77289 8.14083 -8.92279 -4.86777 22.8625 +30 1 4.12817 2.46218 8.33741 8.13153 -11.9637 0.536015 +31 1 4.26337 1.62555 0.809789 -13.061 44.2943 -8.13534 +32 1 3.42316 2.33556 0.802814 -4.29938 0.254861 -1.13643 +33 1 5.0669 1.62594 8.33933 -4.47953 5.08137 -8.2197 +34 1 5.91213 2.40952 0.124369 -13.9 -26.0969 3.99436 +35 1 6.23275 1.281 0.442008 -1.76602 1.09435 0.219677 +36 1 5.05785 2.29128 0.753897 1.63462 9.40663 2.64296 +37 1 6.76196 1.99075 8.08873 7.25593 -6.72787 12.2575 +38 1 7.89568 2.35083 0.217856 -14.3986 10.074 -11.1844 +39 1 7.7557 1.40697 0.992421 -28.0785 15.2332 -13.5573 +40 1 6.69672 2.20109 0.984157 0.465363 17.7913 -13.2761 +41 1 8.2159 3.42858 0.185567 12.3977 0.764361 -3.90376 +42 1 0.927092 4.2442 8.41258 -26.45 -26.3493 -4.33489 +43 1 0.729094 3.09987 0.813639 -4.58702 16.175 15.6607 +44 1 0.0788068 4.49033 1.02182 1.48174 1.40892 2.78463 +45 1 1.55842 3.1508 0.126599 -1.73889 6.5262 3.04002 +46 1 2.29185 4.09245 0.0493365 -0.242842 -5.39025 -0.756334 +47 1 2.41785 3.22623 0.89121 8.0106 -0.183268 -6.38994 +48 1 1.56843 4.03679 0.931375 1.76309 0.26565 -2.14494 +49 1 3.4359 3.23233 0.0225532 -4.36687 10.8322 6.25926 +50 1 4.25669 4.07361 0.0880133 2.8279 3.66932 -9.72921 +51 1 4.34048 3.08558 0.785495 -4.69141 6.70607 0.15029 +52 1 3.59299 3.90329 0.886528 -10.5717 12.5753 -2.99495 +53 1 5.13064 3.04982 8.22833 -0.225212 8.61676 17.0697 +54 1 5.81502 4.09178 8.38841 -21.2737 -2.05468 -24.8502 +55 1 5.97613 3.1773 0.894798 -5.61602 -19.9636 -19.3342 +56 1 5.09497 3.91821 0.747666 0.511602 -0.648627 8.1507 +57 1 6.51767 3.18724 8.3864 17.647 23.2966 -13.5196 +58 1 7.37164 4.03522 8.29689 -11.4262 -6.53116 -1.21962 +59 1 7.31211 3.24078 0.704535 -4.3132 -0.596821 4.84194 +60 1 6.56447 4.1734 0.602333 27.4745 -11.0091 36.7473 +61 1 8.15631 4.68203 0.075112 10.7012 -10.9934 -7.99724 +62 1 1.11663 5.88929 8.3609 -7.93077 -20.1145 9.26986 +63 1 0.996074 4.97243 1.21409 -6.72433 0.768332 -3.74364 +64 1 0.189403 5.66667 0.913187 -7.3538 -1.57168 -7.21317 +65 1 1.58163 4.94764 0.201022 19.1991 11.3216 -0.454803 +66 1 2.29237 5.73911 0.0748948 8.80602 19.0835 -4.47029 +67 1 2.49097 4.65203 0.981363 3.25616 8.72811 -9.97843 +68 1 1.87095 5.55306 0.995907 1.03553 19.7133 11.0025 +69 1 3.18407 5.012 0.131558 5.578 6.2636 9.58863 +70 1 4.09719 5.68255 0.132658 4.03261 5.63654 -2.85988 +71 1 4.12395 4.88832 0.852082 2.34539 -1.75572 -18.9743 +72 1 3.07234 5.70133 0.969327 -0.346407 5.49919 1.56796 +73 1 5.11274 5.00399 0.171908 -9.99815 3.39538 19.3609 +74 1 5.76656 5.80521 0.11529 9.4035 3.26414 21.2303 +75 1 6.01079 5.05469 0.873922 -27.3446 -31.3954 -10.6646 +76 1 4.89913 5.95208 0.960158 8.00863 4.38535 -8.86024 +77 1 6.75863 4.93475 8.31779 -18.6284 14.8779 13.2188 +78 1 7.8245 5.62001 8.34465 11.2383 14.3374 0.909184 +79 1 7.51856 5.31135 0.853265 4.91639 -9.6583 11.5193 +80 1 6.62461 5.81662 0.841147 8.94471 25.6435 -17.3923 +81 1 0.202013 6.46046 8.33455 0.0609498 5.25542 6.45446 +82 1 0.889578 7.53674 8.33221 1.62686 -1.40391 0.0530776 +83 1 0.953366 6.38848 0.908196 -1.46223 4.85455 -5.86941 +84 1 0.145952 7.39993 0.791819 5.48829 -5.75958 -9.51465 +85 1 1.67676 6.71324 8.36121 2.78795 2.25277 6.97945 +86 1 2.21164 7.54618 8.16806 16.5579 9.64776 9.50482 +87 1 2.40278 6.62803 0.856512 -0.674903 -8.3487 -4.56859 +88 1 1.53782 7.38975 0.90846 -3.10291 8.8481 -14.5459 +89 1 3.27325 6.398 0.0420856 1.14847 -3.14438 14.8868 +90 1 4.24204 7.28724 8.33928 2.62398 3.89094 44.6004 +91 1 4.04999 6.6211 0.862788 13.5756 -10.8829 -5.05866 +92 1 3.45704 7.41684 0.605416 -19.3758 10.5723 4.19592 +93 1 5.13383 6.59732 8.2884 -30.4967 14.0841 16.2852 +94 1 5.83566 7.60311 0.0824633 -14.5596 3.16754 7.91958 +95 1 5.71227 6.86684 0.81732 11.5827 -10.7391 -7.91805 +96 1 4.90381 7.61313 0.94797 9.27737 -4.87268 -6.49352 +97 1 6.72722 6.86314 0.253587 -5.2734 -0.113759 -0.620065 +98 1 7.41232 7.77996 0.331703 18.857 -4.07135 -25.363 +99 1 7.56998 6.39348 0.735875 7.28329 1.56003 -0.789213 +100 1 6.66601 7.84216 0.965777 -32.1881 -17.8038 12.8266 +101 1 0.166766 -0.00131261 1.94063 8.32296 1.94608 -3.28266 +102 1 0.934833 0.817938 1.81275 -21.8629 -14.287 17.2076 +103 1 1.00207 0.316008 2.82556 -21.807 -5.91521 -4.01431 +104 1 8.35945 0.74 2.72116 2.32177 4.37751 -0.902675 +105 1 1.48465 8.25372 1.60749 -1.18562 -7.12983 8.20441 +106 1 2.44318 0.774258 1.4766 5.48942 -2.99924 2.57908 +107 1 2.3069 8.18025 2.36522 1.41087 2.4731 2.95424 +108 1 1.85775 0.858752 2.6061 9.12182 6.5265 -4.79678 +109 1 3.23269 0.0488049 1.82801 0.784922 27.4455 -30.2613 +110 1 4.21175 0.99942 1.57195 -9.49462 -27.3711 22.4225 +111 1 4.21293 0.25409 2.38861 -7.75181 -9.25535 -4.23311 +112 1 3.32934 0.964581 2.65137 -6.01516 -9.0041 -1.19732 +113 1 4.9787 0.193499 1.50831 -4.98755 -8.3429 -3.28083 +114 1 6.09517 0.531101 1.76326 -28.5995 19.6806 -10.71 +115 1 5.85753 8.23852 2.51303 -1.20503 -8.99564 8.87124 +116 1 5.17785 0.685106 2.40543 -1.30449 11.3507 4.36005 +117 1 6.91213 8.37413 1.83271 8.62238 -24.2277 10.2354 +118 1 7.62368 0.758482 1.85178 16.0234 8.8439 -5.1341 +119 1 7.66132 8.34118 2.51601 5.03438 -8.87196 18.1761 +120 1 6.82917 0.875718 2.51872 -7.12717 1.70889 8.15245 +121 1 0.0949053 1.53257 1.83348 -15.8355 -28.5862 13.9628 +122 1 0.822415 2.21502 1.73119 16.0449 19.2167 -17.682 +123 1 0.864878 1.50475 2.57372 12.4143 -0.0682656 8.67505 +124 1 0.199844 2.34986 2.54349 -13.4424 7.82132 10.7389 +125 1 1.68463 1.52556 1.71378 7.71699 13.5023 1.83995 +126 1 2.69369 2.59616 1.91546 -20.6965 -6.26723 -3.29779 +127 1 2.60471 1.76603 2.62425 -5.19989 2.78858 2.334 +128 1 1.44056 2.43723 2.51936 11.6798 4.82752 9.65183 +129 1 3.43446 1.65477 1.84942 -9.01773 7.52097 -5.37653 +130 1 4.19061 2.39179 1.65045 11.7616 -7.21515 -2.54075 +131 1 4.26672 1.39737 2.67586 10.1937 6.39563 -7.12371 +132 1 3.53921 2.577 2.549 6.10272 -3.10086 8.1996 +133 1 5.17395 1.33784 1.40963 0.810412 -15.8822 3.29742 +134 1 5.74074 2.13809 1.54869 21.9361 25.9957 -3.59082 +135 1 5.9363 1.515 2.34901 -9.46258 -12.7333 10.9894 +136 1 4.95982 2.19781 2.39856 0.709797 0.431383 -4.3853 +137 1 6.78917 1.32128 1.47071 -5.63197 2.68115 20.8841 +138 1 7.62581 2.16504 1.87345 17.6788 -6.34038 -2.38007 +139 1 7.68847 1.62015 2.88771 -1.999 -29.1097 -18.0204 +140 1 6.72066 2.18015 2.22288 -25.5596 -3.13399 14.9826 +141 1 8.10556 3.24278 1.47587 8.10057 -1.81275 -31.7951 +142 1 0.698788 3.89936 1.58833 21.0059 -8.7854 2.84332 +143 1 0.726156 3.39424 2.59236 2.18368 -0.846434 0.375997 +144 1 8.21488 4.03893 2.09204 -9.31366 21.6556 21.1016 +145 1 1.61294 3.13444 1.56982 -6.75222 2.4564 11.7453 +146 1 2.47309 3.97186 1.76449 2.21347 -7.98753 7.5428 +147 1 2.67292 3.22702 2.95068 5.54423 5.59107 -13.8219 +148 1 1.72826 4.2557 2.53344 -3.42962 -20.862 21.8798 +149 1 3.48214 3.13902 1.56572 3.70104 11.9942 4.11222 +150 1 4.3885 3.8788 1.62665 2.95307 16.2819 -22.5535 +151 1 4.3065 3.38859 2.48531 -9.81397 -19.0665 24.4754 +152 1 3.47101 4.13314 2.35987 0.052847 -5.96917 4.43729 +153 1 5.11162 3.02695 1.57487 -2.09605 4.71156 2.60925 +154 1 6.05823 3.77666 1.6683 -0.0795953 27.02 22.5131 +155 1 5.89604 2.8633 2.33341 1.61726 0.0933652 1.12851 +156 1 5.29152 3.73349 2.43504 2.35223 15.5067 -10.4051 +157 1 6.82698 3.04592 1.66447 4.37333 2.796 -3.08497 +158 1 7.47158 4.33914 1.21316 -2.11938 -7.51647 -10.9268 +159 1 7.68828 3.1018 2.37066 -8.14673 6.79824 16.7729 +160 1 7.09384 4.0081 2.08909 -5.93874 -19.0069 4.73504 +161 1 8.1255 5.22391 1.77055 19.2122 -25.3413 6.96334 +162 1 0.62612 5.90176 1.99772 9.96713 -14.5554 -17.3464 +163 1 0.76801 4.79289 2.36504 -2.78355 1.48316 -1.85895 +164 1 8.18318 5.95034 2.62286 5.26633 -16.349 1.23379 +165 1 1.81648 4.94963 1.84319 1.29255 4.07737 -28.8924 +166 1 2.40619 6.07189 1.89723 9.11627 0.0929027 -31.5253 +167 1 2.58707 5.01704 2.50938 -14.4694 3.44726 -14.5204 +168 1 1.72272 5.71364 2.51972 -25.0056 3.38939 29.4203 +169 1 3.42498 4.85355 1.57173 -14.1697 1.2804 16.3608 +170 1 4.15303 5.79502 1.71807 -6.58651 -0.238746 -3.12281 +171 1 4.46167 4.86212 2.18786 -1.52672 -11.6836 -0.120829 +172 1 3.29589 5.94757 2.4039 5.86702 -13.0661 19.8541 +173 1 5.03295 4.96131 1.30642 14.6935 -5.33684 5.62219 +174 1 5.82775 5.80433 1.62537 -3.48018 5.04048 -3.36734 +175 1 5.79583 4.80394 2.11298 -5.34853 -5.63002 0.159279 +176 1 5.01708 6.04912 2.32216 17.4276 -29.4439 17.4564 +177 1 6.71539 5.10912 1.63093 10.3915 -7.52696 11.1074 +178 1 7.41693 5.91425 1.78268 -24.8131 17.7871 4.30264 +179 1 7.12646 4.86445 2.63426 13.6393 21.9613 3.08537 +180 1 6.42336 6.18201 2.43584 15.1603 10.9548 -7.96948 +181 1 8.23881 6.55347 1.60468 9.12903 0.565206 1.23333 +182 1 0.678624 7.37322 1.88745 -5.46988 3.49615 -25.4292 +183 1 0.794621 6.6529 2.67297 0.0873755 -1.33888 6.26964 +184 1 8.30959 7.39568 2.5723 10.9372 15.1486 20.2523 +185 1 1.53592 6.72715 1.69313 10.3025 -8.32698 21.6565 +186 1 2.52873 7.48993 1.45805 2.51224 9.72508 0.958573 +187 1 2.57516 6.97533 2.39376 0.331622 5.62636 7.11361 +188 1 1.48127 7.49186 2.513 25.359 1.87736 0.862705 +189 1 3.42472 6.67917 1.69715 -9.14691 10.5288 -4.39359 +190 1 4.07864 7.56162 1.54537 -20.7523 -1.21573 5.0956 +191 1 4.22077 6.65705 2.50099 -12.9989 13.269 2.80638 +192 1 3.32476 7.76609 2.51834 12.0821 -31.6775 22.1813 +193 1 5.18316 6.78911 1.6853 -16.2098 8.5059 -12.8052 +194 1 5.76367 7.66024 1.61411 8.21393 8.40414 -2.16429 +195 1 5.72928 6.97443 2.55641 -4.2085 8.68736 -3.41382 +196 1 4.81509 7.65411 2.27112 9.64741 4.31731 11.3389 +197 1 6.71673 6.6577 1.40921 -4.23135 13.1654 3.72162 +198 1 7.9523 7.57862 1.62003 -19.0505 2.7611 2.11499 +199 1 7.55182 6.74669 2.5625 -26.4699 -4.16644 -1.81267 +200 1 6.71006 7.32273 2.23599 -2.19037 10.3011 3.68982 +201 1 8.3209 8.25724 3.44082 -11.2006 13.9316 -31.0885 +202 1 1.1383 0.707726 3.88488 2.87074 16.2111 -29.5751 +203 1 0.710637 8.17953 4.00977 26.7141 2.01724 45.2521 +204 1 0.017483 0.84611 4.17688 -4.01486 -16.4278 3.15279 +205 1 1.83485 0.022043 3.36625 6.99225 9.16158 -10.2142 +206 1 2.5734 1.02544 3.4638 -2.67645 -0.861554 5.53773 +207 1 2.46831 8.35234 4.18841 -8.88118 2.57467 1.82808 +208 1 1.9704 0.882634 4.50547 -3.01692 -0.258051 -7.68015 +209 1 3.15194 0.11929 3.26603 1.99843 -0.203753 6.521 +210 1 4.16362 0.594977 3.39201 1.91533 3.30238 12.0146 +211 1 4.48096 8.3197 4.27248 -34.7907 27.9025 -6.28307 +212 1 3.49096 0.991035 4.39487 -18.0924 -11.2469 -3.89782 +213 1 5.15221 8.33246 3.40287 -4.49662 4.44033 -5.3065 +214 1 5.83668 0.780008 3.22544 8.18869 5.41063 4.37051 +215 1 5.71056 8.31473 4.3397 -0.683085 13.1798 -1.88784 +216 1 5.01734 0.796017 4.33297 -1.83196 10.7479 -11.7081 +217 1 6.55531 0.0226915 3.33292 8.64001 -7.40459 4.85944 +218 1 7.40254 0.734891 3.44283 9.92215 2.2266 -9.49047 +219 1 7.60175 8.41313 4.17692 -11.7492 9.12522 14.6015 +220 1 6.69717 0.884026 4.20434 -2.52907 -5.48675 3.38708 +221 1 0.266587 1.50956 3.42506 -7.49445 4.66836 1.70669 +222 1 0.834612 2.3929 3.4535 3.19311 14.9998 -2.79098 +223 1 0.966342 1.70753 4.27772 -2.38166 -3.63555 7.29451 +224 1 8.31528 2.54359 4.03878 16.7451 -1.36482 20.306 +225 1 1.65675 1.69619 3.39484 3.12529 -6.34044 -1.62009 +226 1 2.21998 2.62053 3.66497 -8.94713 -4.89956 5.05059 +227 1 2.70158 1.84855 4.22365 -4.21065 -7.00328 -1.279 +228 1 1.73069 2.39291 4.69998 -11.0397 -15.2385 -11.7518 +229 1 3.63597 1.81901 3.49635 -5.37102 -6.0004 0.428615 +230 1 4.5181 2.45307 3.50704 1.92291 5.38714 1.37796 +231 1 4.28022 1.61295 4.532 11.684 13.523 -0.759472 +232 1 3.49161 2.67545 4.21356 3.70186 4.50981 -2.53687 +233 1 5.05676 1.45985 3.45113 -18.7528 -7.6908 -2.02124 +234 1 5.59639 2.31007 3.23954 13.071 6.11501 -14.1907 +235 1 5.90515 1.58558 4.07201 2.34854 -1.44676 5.83562 +236 1 5.6448 2.61062 4.20904 5.92031 11.7583 11.4648 +237 1 6.60245 1.81532 3.22394 -0.344578 -17.0844 -10.2298 +238 1 7.7209 2.5366 3.23021 -13.9757 26.3091 7.5372 +239 1 7.59991 1.69339 4.17685 -3.31209 -2.6982 -2.62135 +240 1 6.7571 2.48096 3.97019 3.90879 12.298 15.8753 +241 1 8.32132 3.59836 3.32434 15.1974 -18.6025 -8.65377 +242 1 0.758776 4.28533 3.41911 8.12571 10.2206 -6.43372 +243 1 0.714283 3.43939 4.05789 10.8012 -17.4951 -4.32355 +244 1 8.37038 4.20103 4.16336 -19.0683 10.428 -9.16118 +245 1 1.7111 3.58985 3.37102 -4.50013 -9.39619 -9.22108 +246 1 2.7295 4.29586 3.34058 -27.7709 -28.5377 3.76594 +247 1 2.75779 3.49033 4.0215 3.07014 12.8072 -10.7423 +248 1 1.81597 4.04867 4.27403 8.34757 5.06165 3.43123 +249 1 3.63217 3.50284 3.43026 7.64322 -9.23013 -17.5251 +250 1 4.42979 4.3957 3.21235 -5.21891 -3.02116 0.669719 +251 1 4.46277 3.52681 4.13413 -5.3566 -4.51807 -16.5208 +252 1 3.52987 4.30614 4.06609 5.60483 14.7001 10.5939 +253 1 5.31574 3.44078 3.42467 1.48508 -5.70873 13.1076 +254 1 6.44336 4.14284 2.93215 -36.0911 1.99853 0.657603 +255 1 6.52296 3.60341 4.02819 -0.573509 -3.99567 -1.18998 +256 1 5.23388 4.48156 3.97453 6.55779 -4.33302 -0.590571 +257 1 6.75544 3.08581 2.98548 -20.753 -29.7898 -6.93237 +258 1 7.36113 3.83069 3.18965 17.3707 23.8596 11.1094 +259 1 7.68707 3.36428 4.36221 -8.90323 13.3285 -23.8114 +260 1 6.58157 4.70256 3.96292 -12.6487 -1.89838 -2.64764 +261 1 8.03895 4.72186 3.2072 7.03567 0.390199 -0.150374 +262 1 0.641986 5.57832 3.32415 -3.93783 9.97933 -29.9316 +263 1 0.748525 5.2954 4.26917 10.3198 11.1143 16.7142 +264 1 8.33552 6.07931 4.24855 1.05812 -13.5964 19.1647 +265 1 1.90145 4.96491 3.42288 -7.34814 1.12325 1.52157 +266 1 2.61408 5.80343 3.49254 4.58835 0.11833 -14.0758 +267 1 2.80014 5.15473 4.32615 -31.6367 11.9713 -55.3412 +268 1 1.9564 6.07585 4.27618 -9.91164 -20.8823 -47.0179 +269 1 3.37946 4.96765 3.07865 55.664 27.3093 14.9143 +270 1 4.23608 5.59453 2.88525 -18.9133 13.1689 8.33969 +271 1 4.44604 5.19737 4.14454 -7.57666 -13.265 -14.5347 +272 1 3.6416 5.84891 3.83409 2.65328 -4.22633 -4.19185 +273 1 5.15151 5.25659 3.1676 14.0924 -4.2121 3.02426 +274 1 5.82306 6.30397 3.36345 -4.54273 -6.47443 0.566248 +275 1 5.74908 5.5163 4.09569 25.3818 -3.33304 -26.8083 +276 1 4.83867 6.14359 3.79115 -4.65662 -0.583485 3.38738 +277 1 6.22614 5.32285 2.95137 -4.13422 -8.32687 15.6358 +278 1 7.32122 5.97196 3.33835 -0.00434101 -1.28454 -1.88403 +279 1 7.49659 5.17369 4.09183 8.55988 6.64783 3.63555 +280 1 6.75151 6.22479 4.25773 -16.211 -27.6787 -10.8075 +281 1 8.29215 6.64155 3.42114 5.59717 18.8581 -19.6047 +282 1 0.763473 7.56557 3.23404 -12.9198 -1.64007 -15.2341 +283 1 1.0031 6.68313 3.72439 -4.3972 -14.7662 15.3222 +284 1 8.23363 7.61771 4.35977 7.30279 -9.1197 2.90547 +285 1 1.95141 6.6466 3.21786 0.736159 0.439247 -2.07076 +286 1 2.6385 7.59536 3.37124 -4.27783 -4.21174 -0.733124 +287 1 3.13092 6.60025 4.41497 -19.4938 11.5887 -14.0245 +288 1 1.65818 7.53719 3.85187 -1.11019 -9.22082 13.1065 +289 1 3.27775 6.71474 3.27823 1.67015 1.07042 -3.65835 +290 1 4.1525 7.8844 3.3351 -7.70608 -2.7891 -4.06245 +291 1 3.98551 7.08252 4.24517 31.7093 2.51435 -5.83578 +292 1 3.40048 7.93533 4.31596 7.03572 3.0716 -3.37554 +293 1 4.94636 7.13355 3.35885 -28.0161 -11.5072 -5.66389 +294 1 5.84413 7.52046 3.45751 31.3517 19.8289 8.4284 +295 1 5.90459 6.85513 4.30093 -7.30307 7.57049 -1.80424 +296 1 5.01344 7.53745 4.4217 23.0153 -42.676 2.37557 +297 1 6.69892 6.88846 3.31402 6.29068 2.24472 -2.02408 +298 1 7.47533 7.68601 3.37673 -12.6934 -11.1052 -3.87233 +299 1 7.49921 6.86202 4.09322 12.1924 13.0141 4.3943 +300 1 6.67133 7.90635 4.38865 4.30856 -16.1011 -10.8357 +301 1 8.27296 0.0768914 5.12036 9.18301 -5.97843 0.553246 +302 1 0.892643 0.477473 4.83579 -15.0913 15.4009 20.7636 +303 1 0.772154 0.130661 5.99646 -1.43861 1.07866 -2.10387 +304 1 8.25515 0.935072 5.88754 -0.221723 -11.6722 -2.23691 +305 1 1.48963 8.06671 4.97048 16.9477 -1.8997 -3.71962 +306 1 2.57496 1.15847 5.28752 41.8653 -9.27812 4.61709 +307 1 2.98732 0.492219 6.35067 -4.54422 -4.60939 3.20868 +308 1 1.84275 0.524647 5.86961 -0.917224 0.841047 0.660751 +309 1 2.97903 0.200446 5.09803 7.97745 -0.922342 6.62523 +310 1 4.26317 0.578438 5.09777 -3.02519 11.3137 -4.68966 +311 1 4.18994 0.120263 6.02339 -4.93913 2.59189 23.6551 +312 1 3.50295 1.24619 5.79637 -4.00764 -7.55023 -4.67003 +313 1 5.12205 8.32679 5.40632 -5.25746 3.73248 -3.11501 +314 1 5.80677 0.859185 4.97868 15.281 -0.410171 8.11126 +315 1 6.05354 -0.0201647 5.97574 -7.51195 2.16668 5.49645 +316 1 5.29101 1.10125 5.89955 -0.302158 5.37706 -3.33259 +317 1 6.70998 0.244047 5.12411 -32.2188 -6.24411 4.81733 +318 1 7.52467 0.777062 4.96861 20.8677 24.3354 -3.82818 +319 1 7.29721 0.136872 5.99355 7.05953 -3.3845 7.97045 +320 1 6.54852 0.902142 6.09075 8.2259 10.3777 -12.9847 +321 1 8.3753 1.53724 4.98157 2.17311 8.15625 3.98817 +322 1 0.71432 2.51412 5.02068 -12.4966 -5.84806 3.10051 +323 1 0.855781 1.46858 5.93628 -12.4576 1.96544 0.341226 +324 1 8.11454 2.43493 5.75559 5.15623 -3.74122 1.07022 +325 1 1.70238 1.57115 5.35189 -38.5773 5.62525 -16.043 +326 1 2.46473 3.0428 4.8535 14.9609 2.21644 20.6584 +327 1 2.4829 2.11442 5.80082 20.2757 20.5564 -2.76238 +328 1 1.44662 2.4329 5.9576 0.543772 11.9562 -7.2005 +329 1 3.29597 2.05528 5.06702 2.85074 -1.27902 5.48838 +330 1 4.71392 2.67227 4.67311 -16.586 -2.70867 4.26173 +331 1 4.23981 1.93327 5.61065 17.5416 10.5589 -1.008 +332 1 3.69151 2.91031 5.72032 0.213325 2.13196 -1.69169 +333 1 5.26041 1.83667 5.02123 6.06702 -8.01086 0.159199 +334 1 6.29681 2.56022 5.09106 -5.44623 -0.683824 -15.8447 +335 1 5.97089 1.97948 5.90875 -1.39581 -8.65091 2.36208 +336 1 5.32016 2.78712 5.54952 10.0834 -7.57686 9.12967 +337 1 6.76335 1.53665 5.10381 -6.49311 3.28388 -1.62508 +338 1 7.39244 2.59867 4.94069 -6.65618 -18.4022 10.6664 +339 1 7.39034 1.59037 5.98163 7.99848 2.50507 -1.85372 +340 1 6.86792 2.60296 5.96513 8.836 -3.98323 2.68287 +341 1 0.137435 3.52069 4.93684 -4.66205 -5.7882 5.56144 +342 1 0.88525 4.34994 4.6075 2.988 -8.04302 19.8618 +343 1 0.671447 3.60221 5.79043 18.0943 -16.6493 20.2037 +344 1 8.34285 4.28087 5.95434 -19.6744 13.1619 0.969809 +345 1 1.33416 3.36295 4.99473 8.92189 5.92429 -2.5153 +346 1 2.50305 4.23267 5.05465 -27.5248 -20.908 0.492103 +347 1 2.36725 3.37012 5.84923 -17.1073 -9.96579 7.0021 +348 1 1.45211 4.29673 5.57493 7.54138 6.26423 2.50823 +349 1 3.47656 3.71778 4.99943 12.588 -10.9937 -32.8348 +350 1 4.53758 4.28685 4.7978 -5.49767 21.5926 5.59595 +351 1 4.66123 3.56451 5.54467 -12.8933 9.0868 3.25853 +352 1 3.16215 4.0016 5.8872 6.62501 12.8548 34.5501 +353 1 5.39268 3.59146 4.74919 -4.73905 -31.3011 -11.4087 +354 1 5.76113 4.47956 4.9574 18.7428 32.3973 -5.18443 +355 1 5.78815 3.80587 5.78982 -7.10304 0.117864 -2.90029 +356 1 5.02789 4.67913 5.68892 -14.5359 -3.59396 7.83253 +357 1 6.67716 3.56196 5.1655 1.61752 2.79183 -0.67852 +358 1 7.59448 4.24592 4.9803 -6.50366 -1.98045 6.72657 +359 1 7.59718 3.39514 5.76655 2.21878 7.1556 0.646608 +360 1 6.80163 4.43627 5.8851 -3.03056 -0.645399 -10.9559 +361 1 8.29576 5.01058 4.81068 0.626199 13.0736 14.2059 +362 1 1.05047 6.19551 5.02762 -0.156468 -7.32209 -14.0064 +363 1 0.578297 5.15849 5.72641 1.63655 2.26956 0.551951 +364 1 8.23943 6.07268 5.87533 8.87399 -0.526239 1.15285 +365 1 1.76527 5.31835 4.93011 -1.00084 -16.0238 11.4126 +366 1 2.88183 5.91468 5.07925 -22.1885 -17.105 2.25231 +367 1 2.65936 4.93415 6.03537 0.686882 11.6758 -2.90902 +368 1 2.03447 5.84592 5.92534 2.47635 -18.2138 -25.6325 +369 1 3.24392 4.86959 5.11086 62.6624 1.69747 54.073 +370 1 4.07402 5.91621 4.83335 -4.98562 8.578 9.29517 +371 1 3.92826 4.74513 6.11781 2.52773 6.36319 -4.5061 +372 1 3.44964 5.83627 5.89312 16.6713 -3.51566 20.823 +373 1 5.12814 5.53194 4.84592 -22.4422 -5.59515 37.2611 +374 1 5.90308 6.17208 5.1146 -12.9736 21.9443 6.65273 +375 1 5.95357 5.13374 5.81819 6.93561 8.02219 4.14964 +376 1 4.75268 5.76162 5.94655 1.5775 -0.40438 -5.87077 +377 1 6.51586 5.41565 4.90612 17.2134 -26.1979 -1.37429 +378 1 7.5279 5.93793 5.01527 -3.38884 15.9345 -12.1825 +379 1 7.6332 5.21687 5.72128 4.22628 -40.3472 -14.2075 +380 1 6.64022 6.14894 5.87989 13.3598 -6.13205 -0.934618 +381 1 8.34458 6.85129 5.15926 -14.2808 -7.95422 -4.25663 +382 1 0.833911 7.25078 4.85532 9.11386 4.17832 -8.89911 +383 1 1.06673 6.48225 6.01607 -14.203 -6.44505 8.15493 +384 1 -0.0379195 7.65497 5.88016 -1.75378 4.76646 1.63712 +385 1 2.12599 6.69323 4.98422 2.81787 34.3524 37.6883 +386 1 2.84758 7.50703 5.20442 -10.9987 17.1664 -16.5728 +387 1 2.77128 6.71691 5.85642 -9.44911 -10.1768 15.1935 +388 1 1.58013 7.32255 5.72901 16.1676 5.29147 -4.24753 +389 1 3.6768 6.91779 5.33962 13.4611 -20.8664 1.96557 +390 1 4.03881 7.88236 5.22897 2.57592 -0.812644 -11.9679 +391 1 4.4232 6.75921 6.19682 -8.5477 -5.71312 7.44018 +392 1 3.24799 7.72667 6.18249 0.719386 0.220585 -2.48264 +393 1 4.83295 6.89566 5.2507 4.97045 -2.42982 -4.77289 +394 1 5.87897 7.61282 5.14968 -20.2612 -0.49131 -22.7769 +395 1 5.75942 6.67532 6.09541 -7.34504 3.57141 -0.447292 +396 1 5.14318 7.54839 6.30602 2.0724 10.313 -0.219969 +397 1 6.74639 6.92855 5.00696 6.96871 -0.230218 1.29861 +398 1 7.3805 7.8124 5.23875 7.69485 -10.0795 -7.08489 +399 1 7.52596 6.88746 5.90198 -6.42674 1.56965 2.19774 +400 1 6.51888 7.44621 5.87193 29.4637 -7.18826 32.3539 +401 1 8.28476 0.000423359 6.72306 2.02553 19.5279 -19.3713 +402 1 1.01888 0.905848 6.82221 -28.6303 -12.8009 -18.3361 +403 1 1.24262 8.30657 7.44334 -32.4348 0.998186 -42.9826 +404 1 0.0211475 0.824091 7.47144 0.973424 -13.5355 3.24171 +405 1 1.94007 8.12144 6.72811 7.36532 0.254467 -18.2635 +406 1 3.02097 1.5587 6.75498 -16.6323 -17.6578 -2.8331 +407 1 2.39982 0.0370076 7.66598 -2.14889 1.34284 -3.48663 +408 1 1.9688 0.847456 7.09398 30.835 -18.1107 26.5169 +409 1 3.29942 8.17609 7.18194 3.78499 -8.25924 -8.09048 +410 1 3.92844 1.06207 6.75726 8.02723 -15.5891 -9.47025 +411 1 4.52946 0.167766 7.50023 3.36063 -0.839689 -4.02118 +412 1 3.29302 0.728616 7.56048 2.70434 15.6737 2.80228 +413 1 5.10415 0.332413 6.57695 -15.8309 -23.3459 -1.79261 +414 1 5.90656 0.845621 6.88018 -8.12621 13.928 11.6173 +415 1 5.71058 8.18101 7.57391 -10.3063 5.31817 -1.8554 +416 1 4.82988 1.18118 7.265 13.8593 7.32067 6.7543 +417 1 6.57919 8.43785 7.00021 11.8406 5.1504 -4.86933 +418 1 7.5282 0.806752 6.77786 -1.5451 6.42857 5.82496 +419 1 7.48349 8.33572 7.57521 5.34797 11.8467 16.9658 +420 1 6.70557 1.08836 7.47923 9.5713 -7.54062 13.1357 +421 1 0.0382442 1.56126 6.72749 -0.0966071 11.4911 -0.854867 +422 1 0.869187 2.34639 6.83989 -3.61656 -2.89703 1.60294 +423 1 0.999275 1.45672 7.67633 -8.0034 9.48038 5.5647 +424 1 0.139215 2.63275 7.64328 -15.7892 -20.5267 5.19008 +425 1 1.88893 1.53066 6.37684 -7.83006 6.68056 5.79142 +426 1 2.1935 2.73769 6.82665 18.0903 -33.7124 -24.8324 +427 1 2.37018 1.89864 7.50076 -8.8745 -17.5059 -13.2094 +428 1 1.48561 2.41457 7.71452 -8.23366 6.90197 4.22635 +429 1 3.39063 2.48859 6.68098 16.1595 11.6225 -22.1191 +430 1 4.55604 3.04369 6.47522 -16.239 -17.1818 -0.0461326 +431 1 3.92972 1.83682 7.47298 10.0225 0.0134714 -13.9461 +432 1 3.03012 2.73851 7.57823 -7.17652 4.30522 18.5475 +433 1 5.02119 2.07008 6.4546 -13.5258 -22.6225 -4.75661 +434 1 5.65211 2.81921 6.68199 10.7014 16.4385 -2.46135 +435 1 5.81386 1.77715 7.51287 -3.39579 0.139075 -0.667502 +436 1 4.71678 2.54344 7.41951 15.4924 -28.3106 -11.236 +437 1 6.66707 1.83619 6.71865 -2.24275 1.62817 8.66814 +438 1 7.65934 2.42567 6.78337 1.29364 23.1589 -24.9484 +439 1 7.60492 1.76056 7.50233 6.44148 -25.2098 19.19 +440 1 6.42541 2.6971 7.41321 1.20391 11.9169 -7.49803 +441 1 0.132604 3.18129 6.70867 -2.29445 4.14817 -3.79866 +442 1 0.662351 4.17412 6.80772 -12.4952 0.818831 -9.43638 +443 1 0.788837 3.4069 7.65946 13.9586 12.3209 -0.784492 +444 1 8.14087 4.12742 7.481 16.3072 -9.43806 5.16356 +445 1 1.48457 3.42655 6.6105 -23.5819 5.37731 -5.67472 +446 1 2.19532 4.19793 6.62241 18.5812 -12.748 4.0704 +447 1 2.03418 3.35836 7.57671 1.74798 18.3537 22.2752 +448 1 1.46881 4.26381 7.4306 10.5669 6.85755 16.1187 +449 1 3.40116 3.57046 6.96596 -19.5489 -14.8384 -6.51121 +450 1 4.14086 4.23036 7.04697 14.6332 24.1596 -34.0677 +451 1 4.37587 3.46381 7.58097 -0.667569 -11.1793 25.3659 +452 1 3.3081 4.23862 7.84495 3.59222 -23.7983 19.5534 +453 1 5.02719 3.92296 6.55308 10.3874 19.2736 1.42121 +454 1 5.99108 4.37569 6.77029 -42.1869 -21.9594 -11.1356 +455 1 5.60639 3.61515 7.4373 -8.14506 -14.6497 -3.14446 +456 1 5.05417 4.46396 7.7264 -7.96475 -5.84314 -22.6526 +457 1 6.56389 3.51182 6.41915 7.41692 -2.85266 9.06964 +458 1 7.47152 4.32616 6.69237 -6.16955 -7.38805 -5.63513 +459 1 7.53898 3.20716 7.62579 -2.06037 -6.09637 -1.14724 +460 1 6.59589 3.90993 7.45755 23.4751 -0.996001 13.7582 +461 1 8.21483 5.0816 6.83956 12.3265 -1.95746 -0.89439 +462 1 0.465403 5.98278 6.74845 -2.0373 -17.3355 -17.4636 +463 1 0.511394 5.19401 7.82937 -10.2185 -4.74355 -3.50015 +464 1 8.12271 6.05839 7.46163 -7.84524 3.1436 -8.24587 +465 1 1.48514 4.9291 6.5693 -9.22109 4.87392 -22.494 +466 1 2.40623 5.73649 6.97099 14.0591 -30.3418 -0.240996 +467 1 2.41461 4.96776 7.80425 -3.8539 -8.74065 -18.3704 +468 1 1.44923 5.49011 7.41 13.6015 -14.5185 13.7078 +469 1 3.24542 4.75566 7.0008 -15.7357 21.5396 -25.2781 +470 1 4.03587 5.88736 6.84618 18.4928 -13.3364 -12.8531 +471 1 4.10808 5.01612 7.64484 -5.1777 21.728 20.8534 +472 1 3.29694 5.8019 7.54893 0.566822 -11.9233 11.3035 +473 1 4.81889 5.07278 6.77721 5.06549 -4.43332 1.49875 +474 1 5.96641 5.77692 6.72214 -33.9279 46.677 -28.2473 +475 1 5.88193 5.34623 7.60234 -1.49551 -23.3855 17.2998 +476 1 4.83941 5.81133 7.62234 25.0546 -26.9624 -0.550707 +477 1 6.63577 5.08354 6.75153 63.1873 3.33413 5.12133 +478 1 7.44477 5.7383 6.53202 -8.94815 26.2377 30.0386 +479 1 7.45353 4.90407 7.60234 6.61529 10.6464 -15.3985 +480 1 7.05207 6.05238 7.85033 -15.5225 4.97074 -5.49642 +481 1 8.33549 6.95757 6.75022 0.367032 -2.97861 0.255273 +482 1 0.891414 7.50932 6.49478 -4.83629 2.79466 11.3618 +483 1 1.06555 6.40917 7.42656 -9.40876 15.4887 12.6203 +484 1 0.19507 7.80618 7.47535 7.27195 -18.2248 4.26121 +485 1 1.90915 6.5235 6.63557 -10.6214 46.709 18.7487 +486 1 2.60482 7.35009 7.06318 -2.87326 8.86923 -10.12 +487 1 2.54785 6.52686 7.66612 -14.5904 -1.60347 8.59865 +488 1 1.54201 7.28494 7.4147 7.26892 14.9372 -8.95427 +489 1 3.42163 6.7113 6.72693 -9.74068 0.0780566 2.81617 +490 1 4.07503 7.52705 6.85904 11.3718 5.59625 6.13428 +491 1 4.17032 6.5317 7.69612 -24.7224 6.99609 -12.8841 +492 1 3.30541 7.28919 7.8835 -6.45113 3.62128 -9.60987 +493 1 5.18135 6.6767 7.03146 3.30189 -12.2169 -7.11599 +494 1 6.1441 7.48882 6.87735 -8.40006 -9.95553 -2.76953 +495 1 5.99111 6.52776 7.79328 26.4283 6.66779 -19.7705 +496 1 4.88188 7.45813 7.61707 18.1033 18.9899 -14.9739 +497 1 6.70265 6.55612 6.94114 4.37785 1.73726 -4.76735 +498 1 7.52255 7.69097 6.78657 -11.7433 -15.8982 -13.9562 +499 1 7.60662 7.23551 7.85952 12.3776 -11.2962 -9.39843 +500 1 6.63368 7.62048 7.85195 7.88485 3.15928 -11.7162 +ITEM: TIMESTEP +300 +ITEM: NUMBER OF ATOMS +500 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +ITEM: ATOMS id type x y z f_2[1] f_2[2] f_2[3] +1 1 0.233349 8.13006 8.37458 -13.2268 13.2109 8.94155 +2 1 0.896766 0.85308 8.30255 3.22629 3.6978 6.45643 +3 1 0.859864 0.0707018 0.945242 -23.4126 -16.0712 -18.9613 +4 1 0.0588758 0.842768 1.07285 9.62638 -2.91549 -12.4893 +5 1 1.77938 8.21846 0.149185 -27.8434 -16.3109 -1.32989 +6 1 2.24018 0.700289 8.36085 16.269 9.92358 -3.41709 +7 1 2.6315 8.21417 0.711168 13.3859 0.245092 -3.82819 +8 1 1.39092 0.935915 0.985394 12.7346 13.01 -5.10945 +9 1 3.3176 8.39636 8.17869 -11.566 -16.9274 13.6338 +10 1 3.85219 0.815062 0.0370236 10.4004 28.9589 -3.67884 +11 1 4.161 0.0319779 0.627546 1.75904 -7.59281 -2.75644 +12 1 3.11636 0.817642 0.847547 4.80203 -27.6102 -6.44654 +13 1 5.13793 8.3571 8.28888 -5.17208 4.97346 2.0085 +14 1 5.70385 0.905818 8.12031 -17.8373 19.4407 -6.83741 +15 1 5.79877 0.0963845 0.817928 -4.38032 -1.5507 0.666839 +16 1 4.98412 1.21117 0.664665 -21.555 -8.66432 0.346644 +17 1 6.45061 0.296088 8.38812 3.42924 -28.9348 -2.0588 +18 1 7.77702 0.350545 0.295684 -0.731277 11.544 -2.82186 +19 1 7.70462 8.17101 1.16161 -8.03851 17.5755 -13.9844 +20 1 6.86494 0.586624 0.875444 5.58847 2.16197 13.2587 +21 1 0.100678 1.61145 0.0186749 -1.1873 -11.6656 4.66894 +22 1 0.998429 2.3998 8.22988 -7.28085 -4.5005 5.89326 +23 1 0.828996 1.87962 0.867267 -19.2592 -9.93125 -3.90703 +24 1 8.27374 2.4894 0.580898 8.78255 -11.7455 7.53659 +25 1 1.74048 1.62493 8.26739 -9.18296 -12.9889 2.92816 +26 1 2.39558 2.37629 0.0600193 9.87685 24.4855 1.90731 +27 1 2.45445 1.58898 0.877492 -32.2642 -6.64837 2.63885 +28 1 1.65243 2.45558 0.846906 19.966 -6.37675 -0.113589 +29 1 3.02408 1.54485 8.35689 5.59986 -7.64836 -2.85923 +30 1 3.92 2.20197 8.38732 -20.8443 12.2841 2.52306 +31 1 3.77985 1.57027 0.846646 20.9907 13.6119 -1.22324 +32 1 3.10388 2.34584 0.944358 6.32701 23.9593 -3.77688 +33 1 4.85706 1.878 8.25981 8.11354 -3.87323 -9.47245 +34 1 5.78268 2.09333 0.29673 -1.36849 16.4599 4.03726 +35 1 5.97863 1.20376 0.790291 32.0463 2.36619 -11.4383 +36 1 4.88385 2.45634 0.850397 9.78281 -16.7958 -1.62774 +37 1 6.62285 1.61835 8.29579 8.05661 -4.4773 5.02204 +38 1 7.55399 2.56197 8.18132 12.8994 -8.38166 15.4695 +39 1 7.59924 1.47112 0.768275 -0.340381 -2.67871 -5.54587 +40 1 6.74877 2.64386 0.753723 -17.0902 -18.9793 -10.4389 +41 1 8.35722 3.30339 8.29621 3.88209 -7.05803 1.13469 +42 1 0.765977 3.99405 0.477073 10.4517 2.49603 -17.2656 +43 1 0.831221 3.06707 0.900453 -8.35587 -6.78904 7.02328 +44 1 0.140436 4.39767 1.19127 -1.57081 11.5239 1.23833 +45 1 1.55351 3.27393 8.36662 -0.118073 6.26889 7.92677 +46 1 2.48303 4.16731 0.14908 -13.7582 -4.26857 1.92322 +47 1 2.37333 3.17517 1.02067 -14.4692 6.50264 -31.5071 +48 1 1.65701 4.17058 1.15287 -1.5797 -1.97941 -12.8817 +49 1 3.21438 3.21157 0.146996 -20.1594 -11.7694 11.9952 +50 1 4.28321 4.06082 0.235561 -7.01013 0.464645 -7.4456 +51 1 4.00184 2.96868 0.822048 -4.54826 25.7516 -18.5713 +52 1 3.26412 4.08833 0.821613 11.1851 4.36305 6.27367 +53 1 4.93889 3.19103 0.0459746 -2.17639 -1.1271 -7.48927 +54 1 5.93535 4.0528 8.21654 -1.56333 -1.65165 1.96928 +55 1 5.75576 3.15988 0.707778 17.6817 -13.2713 5.13403 +56 1 5.2315 4.02943 0.763223 -0.452475 -6.04463 7.12931 +57 1 6.80967 3.18308 7.98158 -23.2698 3.29018 18.9116 +58 1 7.84937 4.15894 0.139115 -10.2897 11.6744 2.993 +59 1 7.56351 3.24008 0.752033 -0.468845 18.0521 -12.3044 +60 1 6.70326 3.88955 0.624889 -0.941138 0.59008 2.25635 +61 1 0.263315 4.89557 0.260533 -21.3177 5.01328 -15.5704 +62 1 0.767954 5.80979 8.30607 7.59978 -5.84563 1.67074 +63 1 1.01162 5.03409 0.908989 7.54529 2.69929 16.3999 +64 1 8.38725 5.83431 1.00337 3.61589 -4.15339 -6.36164 +65 1 1.65923 4.84747 0.0732901 -12.2718 -7.14452 -1.11973 +66 1 2.34253 5.60198 8.30655 7.91513 22.3685 24.006 +67 1 2.47075 4.92775 0.922768 -5.69599 3.89765 2.66746 +68 1 1.65076 5.8624 1.08155 8.28384 13.1663 -26.7168 +69 1 3.21032 4.96288 0.0718385 6.90275 12.0583 4.83562 +70 1 4.31683 5.81091 8.2445 -6.07106 16.001 24.4162 +71 1 4.0022 5.10933 1.08243 -0.987394 -5.51353 -4.14418 +72 1 3.08952 5.8543 1.08001 20.7019 -13.8856 -23.646 +73 1 5.04193 4.8848 0.236201 -6.75887 8.84809 -11.6728 +74 1 6.01036 5.86922 0.147762 0.616812 -0.708561 -9.8882 +75 1 6.00591 4.76669 0.704892 -5.00399 3.30231 -11.9912 +76 1 5.15986 5.7957 0.727818 -36.1273 9.99449 -4.0864 +77 1 6.87642 4.89744 0.140008 2.16293 1.86546 -13.7103 +78 1 7.84039 5.5603 8.24691 -4.77039 2.45387 6.97935 +79 1 7.61247 4.95216 0.884224 61.5464 5.54866 -31.4574 +80 1 7.13999 5.87097 0.66837 -10.4004 0.446979 -1.0889 +81 1 0.284976 6.68434 0.215945 -19.2498 8.05662 -14.0567 +82 1 0.982876 7.472 8.30358 11.1034 -5.67626 13.795 +83 1 0.874256 6.63686 1.03265 -11.7399 -6.70777 -2.09767 +84 1 0.12523 7.53526 1.06205 -15.5002 -8.52158 -32.9301 +85 1 1.53836 6.56542 0.124336 5.81155 -2.74575 2.70263 +86 1 2.45566 7.24014 0.163939 -13.7862 7.0524 3.90305 +87 1 2.38368 6.64181 1.16489 5.19309 13.0368 -14.4547 +88 1 1.55777 7.42064 0.955187 2.95317 9.919 -9.12596 +89 1 3.26105 6.57879 0.277391 6.19764 -3.88127 -4.29904 +90 1 4.21681 7.50418 8.36589 0.418779 7.33048 -0.673966 +91 1 4.2136 6.71573 0.805769 6.02261 -2.81289 0.798739 +92 1 3.49573 7.57967 0.77094 -13.8185 -15.1907 -22.6007 +93 1 4.97943 6.65519 6.77102e-05 6.49698 2.41559 -0.5205 +94 1 5.78763 7.50739 0.0292034 7.17211 6.93093 1.18788 +95 1 5.70061 6.80412 0.815144 6.83872 -8.02569 -5.22668 +96 1 4.96155 7.64188 0.754906 -1.40971 0.48378 3.60676 +97 1 6.62543 6.75834 0.212141 20.3815 -6.72799 19.0936 +98 1 7.5054 7.54064 0.228699 5.02405 -0.59125 8.31674 +99 1 7.62741 6.7648 0.966544 10.8528 -1.51524 -6.86782 +100 1 6.51764 7.61106 0.794066 -3.58188 15.2202 -2.22905 +101 1 0.0861403 8.39942 1.77523 16.561 5.47177 12.0456 +102 1 0.798241 0.867486 1.90283 5.83429 -6.22483 -1.18959 +103 1 1.01882 8.16093 2.58804 1.69129 37.21 2.68102 +104 1 8.26047 0.933232 2.39213 16.6191 -6.94084 19.3019 +105 1 1.5043 8.31602 1.70005 24.5225 8.22354 6.48742 +106 1 2.3278 0.505699 1.44491 -1.87805 7.24432 12.5632 +107 1 2.30107 0.0675885 2.61736 -2.34035 -25.4089 0.204635 +108 1 1.65389 0.877547 2.65941 -7.28266 6.33447 -16.1438 +109 1 3.50019 8.31721 1.47862 -16.7888 14.1081 10.898 +110 1 4.01956 0.825924 1.54962 -26.8746 12.2857 6.16059 +111 1 4.07538 0.019132 2.44171 -4.87493 0.404402 -2.17065 +112 1 2.869 0.885962 2.4149 5.17917 -2.47967 0.533766 +113 1 4.73464 0.155071 1.4932 30.6868 -26.2406 6.98684 +114 1 5.62968 0.817396 1.64834 -4.04481 -8.77462 16.8173 +115 1 5.66865 0.0141325 2.50366 17.0023 -1.89327 -13.9307 +116 1 4.86842 0.817468 2.42132 32.27 -13.4362 -6.77265 +117 1 6.59541 8.31415 1.73549 -0.21361 15.3936 4.52423 +118 1 7.59767 0.742823 1.6565 -21.3952 4.75735 -8.6823 +119 1 7.60945 8.3635 2.38741 -3.47518 -4.35582 8.08118 +120 1 6.64964 0.766964 2.59458 1.86331 7.94862 -15.7507 +121 1 0.0966564 1.72383 1.66126 -2.3646 2.96568 -2.77323 +122 1 0.838875 2.52792 1.96878 -8.15441 10.7797 -1.95863 +123 1 0.90776 1.65168 2.68747 -10.1162 -2.78056 -2.47535 +124 1 8.34426 2.2614 2.55151 21.19 -10.0612 15.2043 +125 1 1.46427 1.72978 1.76157 8.28796 -9.22695 -3.48387 +126 1 2.37501 2.29161 1.76614 -0.0664736 7.90276 1.49641 +127 1 2.67166 1.85508 2.81423 -4.33867 8.71682 -6.36279 +128 1 1.69129 2.40006 2.69001 -6.84808 74.503 -77.1336 +129 1 3.2606 1.69371 1.92128 -6.02725 -3.6159 -16.3817 +130 1 3.94104 2.38885 1.63591 5.99851 11.0997 18.049 +131 1 4.04449 1.32304 2.52718 -28.9333 17.8748 13.0885 +132 1 3.64404 2.34301 2.71879 -4.29604 2.09188 -4.97764 +133 1 4.64091 1.6418 1.58405 19.1918 -0.189122 5.88078 +134 1 5.88395 2.31133 1.52544 0.0797298 5.40617 -9.4435 +135 1 5.7987 1.64961 2.35436 -3.46325 -3.79932 12.9903 +136 1 4.78244 2.22308 2.51874 2.01011 -1.75623 -4.81914 +137 1 6.65439 1.55727 1.69251 0.0481382 -10.7878 -2.86985 +138 1 7.4609 2.22018 1.51079 9.36137 15.4008 -1.67913 +139 1 7.50576 1.63853 2.4128 -2.97032 -17.2864 -0.621812 +140 1 6.87214 2.43415 2.42038 -30.5876 3.19651 2.74052 +141 1 8.27498 3.12542 1.46263 16.9155 1.32854 13.6822 +142 1 0.778659 3.95642 1.86807 -7.25106 -12.2522 -5.40095 +143 1 0.798965 3.10856 2.99966 -8.51883 26.4353 -21.6316 +144 1 8.39629 3.85082 2.58225 -5.99614 1.48776 4.40527 +145 1 1.68381 3.21805 1.79101 -5.77633 -5.0861 7.47296 +146 1 2.56903 4.03114 1.71918 -6.92524 18.9919 2.42009 +147 1 2.68821 3.054 2.58052 -0.955464 -0.812242 -0.180548 +148 1 1.68992 4.20726 2.20027 5.368 3.11181 32.2719 +149 1 3.19042 3.29104 1.54336 50.4233 -29.9172 14.5641 +150 1 4.30208 4.0236 1.30142 -3.92395 -1.77865 11.4065 +151 1 4.28898 3.18994 2.59219 8.96711 6.3942 -10.7611 +152 1 3.60727 4.0096 2.21837 0.742083 4.13896 4.48687 +153 1 5.11886 3.09922 1.66619 -2.87182 6.36609 5.71268 +154 1 5.98984 4.3721 1.6574 7.23512 -22.1503 15.9695 +155 1 6.06757 3.38048 2.48886 -0.631751 -1.09061 1.54872 +156 1 5.04095 4.05582 2.29794 7.98224 -6.57422 -3.38111 +157 1 6.80585 3.23363 1.61955 1.81547 4.43083 5.90353 +158 1 7.6107 4.12271 1.4985 -13.6918 -18.0547 7.51636 +159 1 7.71076 3.00605 2.3508 1.14441 21.4666 -12.0177 +160 1 6.92831 4.10176 2.31565 -3.92153 2.58619 4.8482 +161 1 8.33973 5.1724 2.08404 -22.306 -14.8391 -35.8531 +162 1 0.860537 5.83051 1.79504 -25.5953 10.3696 1.23396 +163 1 0.802813 4.96181 2.52052 20.0549 -14.1798 16.2425 +164 1 8.20479 5.88748 2.7573 8.86056 43.8975 -14.7096 +165 1 1.62556 5.15881 1.79421 13.6671 -60.0224 -43.8322 +166 1 2.44832 5.82052 1.83706 -21.0979 -8.85922 15.9808 +167 1 2.35829 4.95884 2.60055 5.56499 -3.25718 -17.7316 +168 1 1.57047 5.68188 2.57793 3.26945 48.3874 60.3367 +169 1 3.12962 4.94115 1.79611 3.44797 3.66295 -7.67081 +170 1 4.533 5.88518 1.61818 -3.82507 3.84853 0.541056 +171 1 4.41047 4.91386 2.27111 -7.04817 9.97354 -0.554451 +172 1 3.1705 5.97206 2.56867 13.8835 0.36015 7.54685 +173 1 5.10201 4.84379 1.45925 -8.99072 13.7146 -7.42642 +174 1 6.04077 5.71462 1.17105 24.8221 7.94918 20.2395 +175 1 6.02655 5.34395 2.16117 8.67798 2.32994 -0.236737 +176 1 5.13754 6.13757 2.45889 -19.0768 2.88926 -22.199 +177 1 6.81157 4.98564 1.3948 -36.2833 4.79272 33.0954 +178 1 7.60086 5.99469 1.7372 -3.24829 -8.45789 -2.93345 +179 1 7.33283 5.34101 2.57932 2.07328 -12.097 -6.46632 +180 1 6.77196 6.24125 2.34214 -17.3674 -5.70799 13.1243 +181 1 0.0250537 6.6606 1.72753 8.49396 4.93702 8.33356 +182 1 0.795762 7.59079 1.77266 12.7999 -27.3678 15.1487 +183 1 0.926657 6.70523 2.69571 -0.793657 3.91691 -3.18748 +184 1 0.160908 7.59778 2.74546 -5.44053 4.97464 -19.9661 +185 1 1.54893 6.69469 1.77147 8.37496 4.15768 30.0144 +186 1 2.38553 7.66265 1.59156 1.85092 -2.31642 6.75994 +187 1 2.52893 6.74213 2.34554 9.20138 12.1517 -25.6716 +188 1 1.80175 7.4451 2.61158 -6.78811 17.5009 -13.1399 +189 1 3.38458 6.74038 1.57533 -10.1646 -3.59545 3.61897 +190 1 4.095 7.47851 1.58866 27.0187 15.4009 2.51878 +191 1 4.11379 6.83 2.37783 19.5598 -18.1657 -14.1463 +192 1 3.12959 7.71074 2.36405 10.6634 -2.49932 -15.2866 +193 1 5.08729 6.94297 1.62592 -21.1801 -24.4484 5.07107 +194 1 5.73581 7.71377 1.57745 5.16642 11.3097 -0.890489 +195 1 5.92001 7.08484 2.45291 -0.193261 -0.933403 -1.70059 +196 1 4.83819 7.59024 2.39768 8.18574 14.9342 11.0206 +197 1 6.61545 6.66525 1.38958 -18.6406 -25.8802 -11.2439 +198 1 7.15994 7.45994 1.57935 11.6501 4.19084 33.778 +199 1 7.56748 6.9114 2.40976 10.0926 4.81165 9.43494 +200 1 6.80428 7.72449 2.78938 -1.24224 -1.60677 -10.8659 +201 1 0.159784 0.136544 3.24366 -1.32953 4.05967 1.66335 +202 1 1.00698 0.811307 3.51207 1.50245 1.78035 6.01503 +203 1 1.34713 0.12551 4.66914 -24.521 -31.0514 3.16868 +204 1 0.0655245 0.668593 4.25847 -0.855275 2.59789 -3.35749 +205 1 1.74942 8.37675 3.57933 -10.207 -16.1779 -1.21978 +206 1 2.26863 0.82911 3.48792 22.6881 17.8048 9.09595 +207 1 2.33553 0.183914 4.4711 16.8323 -1.13179 -15.08 +208 1 1.7049 1.03332 4.4695 6.78822 33.3459 -7.07653 +209 1 3.29237 0.411287 3.32326 -2.12858 -4.79866 -0.866625 +210 1 4.21141 0.796867 3.72276 15.2258 15.2508 -15.0202 +211 1 4.33441 8.33993 4.30342 13.6521 7.25398 3.1725 +212 1 3.45786 0.725922 4.42039 -13.4693 -6.1715 4.46767 +213 1 4.89231 0.0473082 3.15782 -6.25621 1.30634 20.3282 +214 1 5.77362 0.736119 3.37748 -9.09312 1.23928 -13.4649 +215 1 5.99071 8.04065 4.47949 -15.8189 13.2428 -8.46949 +216 1 5.196 0.682234 4.2587 4.7081 -6.90451 -0.266688 +217 1 6.57106 0.145322 3.40637 19.3462 -23.2913 17.9258 +218 1 7.59401 0.663732 3.46257 -2.8602 2.11131 -2.24016 +219 1 7.44242 8.25412 4.2449 1.11307 19.9225 9.74876 +220 1 6.62382 0.709572 4.35284 3.66026 3.16927 -3.64727 +221 1 0.0779483 1.38159 3.37319 -4.4953 5.38733 3.01304 +222 1 0.974278 2.30233 3.53228 -23.5961 -13.9704 29.7447 +223 1 0.524182 1.77379 4.53785 8.44119 -12.0369 -19.76 +224 1 8.32657 2.54461 4.19453 11.685 -8.01921 4.29442 +225 1 1.79699 1.78778 3.36592 20.9053 -94.2146 75.3552 +226 1 2.26904 2.65097 3.69138 3.64635 0.74501 -3.21688 +227 1 2.67429 1.70202 4.43144 -1.62218 -6.52331 -3.16444 +228 1 1.67869 2.25152 4.52595 21.8057 -26.9163 -24.6655 +229 1 3.42529 1.64095 3.50559 7.24234 -14.969 7.63922 +230 1 4.36843 2.51227 3.48596 2.07064 -5.87084 11.4812 +231 1 4.83369 1.71242 4.31187 -12.4342 -5.24453 -2.55025 +232 1 3.42697 2.55135 4.03879 13.1661 -11.4647 -6.22039 +233 1 5.09889 1.5127 3.30322 -10.1348 7.40169 -7.59726 +234 1 6.05204 2.45182 3.35855 -5.34479 4.21286 -4.99107 +235 1 5.91247 1.54121 4.03978 -1.19872 3.24833 9.47786 +236 1 5.34566 2.59829 4.30389 3.31953 7.26855 -16.7286 +237 1 6.74657 1.65018 3.27179 -23.12 -29.0051 -3.67746 +238 1 7.53263 2.23686 3.30386 26.344 22.8452 7.39879 +239 1 7.49613 1.58204 4.21155 10.9589 -18.8504 -4.35663 +240 1 6.70452 2.2326 4.19472 -13.7578 19.073 -7.70781 +241 1 8.04948 3.18864 3.48276 7.81989 17.0755 -15.6642 +242 1 0.420364 4.02026 3.62891 2.0762 -18.0048 -13.8871 +243 1 1.02911 3.20723 4.10028 2.87528 5.61338 3.46722 +244 1 8.23518 4.59996 4.24867 -9.72892 -14.3069 11.6196 +245 1 1.79813 3.62221 3.14835 -2.38332 -26.1643 0.00682256 +246 1 2.74246 4.09054 3.06778 10.2172 -0.241531 -5.01738 +247 1 2.65108 3.56469 4.0066 1.29528 2.95166 -0.450344 +248 1 1.68753 4.16642 4.41008 0.531244 0.36282 -0.905409 +249 1 3.56157 3.26659 3.34031 -15.156 16.0178 -13.2173 +250 1 4.30786 4.20161 3.07587 -3.71718 9.6458 -20.0534 +251 1 4.29173 3.71129 3.93288 2.63232 -25.6185 20.4798 +252 1 3.34785 4.41255 3.95574 4.30294 0.337698 1.30747 +253 1 5.19196 3.15058 3.27975 2.68017 7.34728 -0.723223 +254 1 6.11836 4.37563 3.09786 3.48097 -0.455645 -7.15348 +255 1 6.16379 3.4966 3.8024 -0.493793 0.0328113 2.1336 +256 1 5.30251 4.52711 3.80393 -16.2632 -25.1941 -0.0075048 +257 1 7.08947 3.30091 3.10932 -23.6486 5.19633 4.56168 +258 1 7.44697 4.43668 3.27896 -0.511887 -2.93371 -0.292771 +259 1 7.26132 3.68038 4.11877 19.5278 5.77559 -31.2062 +260 1 6.65227 4.59556 4.02535 -2.98634 0.729124 1.77093 +261 1 8.32438 5.07972 3.31456 7.45197 -18.3523 8.49382 +262 1 0.7239 5.87238 3.35063 13.9037 -7.68163 -11.6827 +263 1 0.86133 4.86733 4.0112 5.23908 17.06 9.33784 +264 1 0.110376 5.99228 4.15088 -19.5006 -5.14624 15.1727 +265 1 1.63326 4.60922 3.31023 -1.76723 17.8491 2.08855 +266 1 2.40135 5.61695 3.38494 19.4662 4.44663 -11.3673 +267 1 2.36184 5.08435 4.31966 -1.81965 -14.9274 -8.60789 +268 1 1.71701 5.94552 4.03684 -24.0402 -0.0953197 5.79012 +269 1 3.43912 4.9954 2.79577 7.89838 -10.7079 17.2388 +270 1 4.22838 5.86109 3.02821 33.6181 3.37383 -45.0173 +271 1 4.24887 5.06359 3.71273 2.64953 -0.546445 2.15952 +272 1 3.55742 5.92395 3.71083 -38.5919 -3.44905 39.4056 +273 1 5.41837 5.23828 2.98577 -11.447 -4.74628 10.7983 +274 1 5.86494 6.22754 3.11739 14.9731 7.40151 22.8162 +275 1 5.75467 5.37436 4.08221 13.6205 23.921 6.83069 +276 1 4.77382 6.13694 3.95439 -2.74813 -13.8938 10.4295 +277 1 6.55906 5.4789 3.24844 0.234698 -8.05013 11.4476 +278 1 7.53331 6.151 3.48116 -10.0459 9.16913 -20.7264 +279 1 7.59712 5.40949 4.12314 -10.2706 -23.4933 17.211 +280 1 6.76315 6.15422 4.20451 -8.32818 -2.13306 4.306 +281 1 8.33074 6.79274 3.30017 10.9969 -9.86444 14.3566 +282 1 1.03943 7.60681 3.41422 12.8839 -22.0033 7.43641 +283 1 0.876997 6.68124 4.1033 12.4942 12.9257 -7.86127 +284 1 0.320289 7.62896 4.11358 -19.9566 8.93301 7.64028 +285 1 2.12233 6.73507 3.25947 -6.36672 -13.9408 34.1069 +286 1 2.9278 7.71082 3.35699 -9.10575 13.9767 3.53664 +287 1 2.86555 6.96099 4.04549 -8.29151 -16.9355 4.68952 +288 1 1.89553 7.49272 4.25249 -6.95602 2.25366 -4.36835 +289 1 3.55128 6.82828 3.17739 -22.1877 4.18931 17.356 +290 1 4.1661 7.71123 3.4095 -5.10369 -4.69259 -0.796458 +291 1 3.89274 6.87937 4.19693 15.4298 1.82254 7.44647 +292 1 3.39266 7.95134 4.30177 -1.7872 -21.2114 -27.9517 +293 1 4.99714 6.86548 3.27273 -3.15325 15.5146 -9.80269 +294 1 5.7604 7.67976 3.37293 2.05238 1.22428 3.6757 +295 1 5.73479 6.76996 4.15088 6.33474 -4.66485 -1.392 +296 1 5.07616 7.57695 4.40446 -13.6351 -7.42167 0.514113 +297 1 6.73778 6.81794 3.33301 -3.54485 0.402493 -5.08336 +298 1 7.71498 7.67053 3.44695 -0.752689 -3.6099 -11.6949 +299 1 7.71759 6.87965 4.22182 -5.11403 5.07303 3.22293 +300 1 6.7649 7.45476 4.17956 6.56157 -12.3801 -0.724651 +301 1 8.19197 0.136233 5.17288 2.67067 20.6746 -19.9914 +302 1 0.776102 0.931351 5.08619 -1.70464 -8.91233 1.85235 +303 1 0.888781 0.0179834 5.65999 -4.55543 21.0031 13.534 +304 1 8.38466 0.737331 6.00004 -6.63761 5.81892 -3.68334 +305 1 2.17326 8.16764 5.48567 -30.0571 8.40977 9.50779 +306 1 2.68565 0.975823 5.34104 11.1467 5.8174 -19.2362 +307 1 3.06444 0.336871 6.1128 1.74673 -5.08128 15.5867 +308 1 1.94778 0.751629 6.0231 -12.5402 -6.77103 11.9096 +309 1 3.09215 -0.0018856 5.12048 23.3711 9.80891 31.3016 +310 1 4.54285 0.96074 5.03055 -10.8439 -8.47943 8.00065 +311 1 4.19772 8.25187 6.2874 -2.87662 7.25597 -11.3947 +312 1 3.73883 1.45482 5.73884 -5.31372 -3.16529 -7.8226 +313 1 5.15615 8.35466 5.42348 2.42368 -1.79965 -6.24325 +314 1 5.91471 0.891384 5.15303 -5.07011 -3.09253 -0.460458 +315 1 6.03745 8.35632 6.14961 -1.39208 3.8678 -5.18235 +316 1 5.2121 0.86593 5.98804 -13.8254 0.446509 -12.536 +317 1 6.68868 8.34181 5.14194 3.9888 6.48649 16.9974 +318 1 7.34021 0.809849 5.26372 -2.78853 -11.1974 -10.3326 +319 1 7.36245 8.30575 6.05369 1.98185 25.0408 -10.0092 +320 1 6.64158 0.85851 5.99168 -3.68623 1.19752 6.36998 +321 1 8.13309 1.40671 5.10096 17.8835 4.45702 -4.02515 +322 1 0.892662 2.59499 5.00421 -20.8235 21.437 24.4928 +323 1 0.773043 1.57142 5.91415 4.22614 9.86073 2.56515 +324 1 8.33239 2.57823 5.60038 -0.623629 0.0892147 1.2306 +325 1 1.87225 1.66498 5.43985 -2.48264 -4.0236 -4.58226 +326 1 2.75473 2.72259 4.73435 -30.311 11.1987 -1.55273 +327 1 2.93165 2.12687 5.49641 -1.73472 -35.7803 16.6222 +328 1 1.7335 2.58373 5.90704 -3.71318 12.7214 1.30751 +329 1 3.77896 1.69526 4.65032 1.63977 11.6216 2.36832 +330 1 4.33882 2.78478 4.62298 7.45227 7.00188 -24.1667 +331 1 4.0935 2.44339 5.52545 -11.3615 -7.17888 20.8862 +332 1 3.18285 3.03749 5.86709 11.7107 14.2608 -10.1303 +333 1 5.16253 1.77254 5.33362 4.38648 8.73211 2.03951 +334 1 5.9743 2.78241 5.0854 16.8461 0.569184 7.37091 +335 1 6.05449 1.8557 6.00418 -1.07841 -2.85482 0.754485 +336 1 5.02736 2.93607 5.49369 -0.394928 -5.32288 -0.0457358 +337 1 6.65738 1.68333 5.09298 2.04945 -3.50949 1.46808 +338 1 7.506 2.4535 4.81544 -2.36267 6.50792 21.426 +339 1 7.5049 1.81157 5.81254 2.0705 -7.66144 9.63716 +340 1 6.81799 2.57614 5.74327 -5.22025 12.4071 0.584392 +341 1 8.08209 3.4329 4.82809 -0.388102 0.733533 -0.302449 +342 1 0.687603 4.05264 4.91973 13.3113 7.10483 -26.1293 +343 1 0.927182 3.40713 5.70883 1.42 -2.21252 8.41121 +344 1 8.39125 4.08596 5.64374 -17.7983 3.69834 21.9629 +345 1 1.85335 3.18328 4.91159 -22.5662 10.1648 8.61749 +346 1 2.62594 3.83741 5.0269 -11.5374 29.2389 12.1219 +347 1 2.23001 3.64598 5.99431 12.2251 -19.0314 6.6066 +348 1 1.61612 4.36322 5.62412 -4.72812 -41.6645 3.65456 +349 1 3.49026 3.4159 4.80384 34.5623 1.92174 -9.26957 +350 1 4.42781 4.48169 4.58587 2.89283 12.0072 14.2383 +351 1 4.32987 3.73273 5.40213 -1.15236 0.923586 4.29704 +352 1 3.35747 3.99106 6.24745 4.6285 19.5949 -5.94829 +353 1 5.1733 3.66262 4.57851 -0.760359 -3.40804 -5.73178 +354 1 5.75745 4.60154 4.93992 12.48 38.3619 -39.183 +355 1 5.60952 3.84508 5.51193 1.72033 -36.6996 37.1733 +356 1 4.90838 4.64872 5.58962 -7.33472 10.9707 -1.22542 +357 1 6.81366 3.55073 4.97382 -24.7572 -16.3635 34.7513 +358 1 7.36231 4.42367 5.08055 17.1166 2.62568 -2.95463 +359 1 7.4725 3.41969 5.92572 4.71216 -0.444272 -3.67252 +360 1 6.56495 4.37474 5.82163 -0.033274 -9.82017 -6.2351 +361 1 0.041011 5.18659 5.08838 -22.5443 6.51501 -27.8507 +362 1 1.02655 6.1046 4.9959 -2.55187 -8.42255 -9.06362 +363 1 0.725543 4.91454 5.73466 12.2313 -2.94426 20.5318 +364 1 0.0422288 5.86356 5.87032 0.0942915 12.4442 -1.56822 +365 1 1.61098 5.19782 5.1268 2.44581 33.2387 -21.9348 +366 1 2.65636 5.69092 5.09384 11.8609 0.215073 14.2086 +367 1 2.6104 4.85981 5.98721 5.66035 -5.70161 -4.77737 +368 1 1.90538 6.1737 5.70769 -41.2624 -24.39 16.3086 +369 1 3.46858 4.77582 5.16944 -0.707582 -1.43422 0.766057 +370 1 3.76426 5.90532 4.89181 3.4437 -1.11423 -2.15979 +371 1 4.07073 4.92867 6.32743 11.4607 -11.4553 -4.32634 +372 1 3.67793 5.86643 6.05942 -4.35866 5.03724 -1.47182 +373 1 4.98792 5.51389 4.93524 -8.4187 -10.8933 -4.11136 +374 1 5.89023 6.01641 5.05179 11.0493 7.97987 -0.316877 +375 1 5.84913 5.21289 5.8287 7.09495 5.60009 -11.1489 +376 1 4.95887 5.92462 6.03819 -1.41241 -1.47294 -8.90972 +377 1 6.72618 5.24569 4.87739 -4.6501 10.2679 6.06598 +378 1 7.69701 6.07801 4.9728 1.45309 -5.4044 1.15049 +379 1 7.57443 5.25318 5.8022 -4.19719 -6.86637 2.5693 +380 1 6.75672 5.96198 5.84181 4.25859 -4.73277 0.116077 +381 1 0.149236 6.9327 4.88187 0.301354 -7.8021 16.5737 +382 1 1.06612 7.54377 5.19235 6.17987 -18.0682 -12.1896 +383 1 0.908663 6.67909 5.83913 1.89859 7.5565 8.00921 +384 1 8.3967 7.73373 5.73713 17.5958 -22.201 25.7152 +385 1 2.09262 6.53099 4.7967 1.84262 19.7267 -15.5304 +386 1 2.6809 7.4184 4.97144 1.84587 -3.02643 6.66108 +387 1 2.76451 6.5131 6.02372 26.4927 9.3308 7.09081 +388 1 1.89235 7.21971 6.07993 -5.61302 23.442 -46.1583 +389 1 3.56452 6.91614 5.29782 1.29026 -2.451 2.37678 +390 1 4.22056 7.80764 5.23329 -2.48711 -3.82055 1.83806 +391 1 4.29263 6.77471 6.12925 7.35038 5.5119 -5.7056 +392 1 2.85273 7.60961 6.07343 16.4578 1.27697 -7.39815 +393 1 4.81773 6.56695 4.97715 -1.40117 8.33727 3.10183 +394 1 5.78811 7.39325 5.43254 7.66799 3.74746 -17.7564 +395 1 5.91597 6.55237 6.07292 -10.3134 0.875812 3.19143 +396 1 5.1536 7.54901 6.2302 -8.62748 1.72241 13.4381 +397 1 6.84976 6.76387 5.09828 -3.19969 2.83039 -4.79256 +398 1 7.54117 7.72913 5.1763 -12.4453 -25.3207 -11.2598 +399 1 7.70324 6.72981 5.83369 -19.5261 3.79708 -10.3274 +400 1 6.77336 7.41197 5.93794 -9.93531 -0.946567 -12.2979 +401 1 8.22949 8.35705 6.76928 1.64244 -1.45449 1.77988 +402 1 0.72004 0.832942 6.72959 22.4465 -5.361 -6.29847 +403 1 0.883022 0.0931191 7.57241 -5.23405 -15.4407 -5.32038 +404 1 0.0468789 0.82113 7.48906 -16.6351 2.71194 14.972 +405 1 2.03902 8.21121 6.63645 7.11775 -8.1199 -7.72414 +406 1 2.8098 1.35985 6.35749 11.4457 2.58538 -2.95276 +407 1 2.39096 8.06897 7.6788 1.19633 7.68608 5.18448 +408 1 1.75996 0.580686 7.28683 6.89284 15.6237 4.36189 +409 1 3.24708 7.93738 6.98795 5.84043 19.9452 -24.3758 +410 1 4.23919 0.919929 6.46503 -1.07654 -9.91612 -5.08402 +411 1 3.90772 0.424381 7.41946 37.0812 -23.6824 -3.45202 +412 1 2.91871 0.505987 7.33506 -26.0302 7.74114 -11.0468 +413 1 4.92803 0.11282 7.09764 -8.28234 1.33652 -4.84063 +414 1 5.89475 1.0043 6.70526 7.29393 0.830325 27.9656 +415 1 5.8956 8.35718 7.44426 -3.02776 0.024361 13.8614 +416 1 4.71342 1.28665 7.29701 10.263 5.35948 11.5905 +417 1 6.8248 0.0574117 7.01961 11.7828 1.29904 -9.90689 +418 1 7.52034 1.04303 6.65362 -4.17639 -6.17679 3.43381 +419 1 7.73603 8.17986 7.79994 1.7859 4.36245 -17.9939 +420 1 7.13318 0.752429 7.78463 13.3591 3.5282 -5.71599 +421 1 8.39243 1.66394 6.67161 -0.134672 7.39125 4.10576 +422 1 0.854509 2.49412 6.65204 0.887161 -2.38052 0.586225 +423 1 1.18138 1.63924 7.31791 -41.6971 -18.352 25.0151 +424 1 0.0943458 2.334 7.66786 0.324396 10.57 -15.5201 +425 1 1.87867 1.74452 6.645 -1.95754 3.46436 -44.2754 +426 1 2.63684 2.47303 6.52845 -8.45632 -20.7999 4.28943 +427 1 2.51699 1.47554 7.37579 1.92109 3.65888 22.6814 +428 1 1.82876 2.39767 7.50566 14.4123 21.9409 0.136363 +429 1 3.78398 2.21463 6.57246 -2.68631 2.13236 -0.792617 +430 1 4.46308 3.07592 6.43555 -3.89191 7.33892 -9.13636 +431 1 3.59875 1.35397 7.20413 -9.98874 22.9069 2.08665 +432 1 3.19396 2.3577 7.56493 -2.6719 3.09783 -0.16421 +433 1 5.06299 2.1644 6.37533 -2.58633 -2.00836 2.79809 +434 1 5.67119 3.15784 6.34996 -0.566548 -6.83481 -5.10746 +435 1 5.66575 1.97666 7.57441 -14.7077 -20.3342 4.08546 +436 1 4.67442 2.64884 7.36908 -6.67424 -36.8328 0.644107 +437 1 6.68154 1.59605 7.24042 -18.9747 -1.14386 -19.0037 +438 1 7.52504 2.47849 6.70825 -1.30537 -8.16455 -5.2397 +439 1 7.60687 1.7083 7.61907 22.0172 -9.53549 -2.5479 +440 1 6.29708 2.66318 7.23348 12.1765 11.0009 -15.9537 +441 1 0.116615 3.32613 6.70965 -8.35482 -2.36763 -31.1169 +442 1 0.754871 4.30259 6.64315 -6.49201 3.33528 -9.76479 +443 1 0.673999 3.30917 7.54182 21.55 -11.008 11.6004 +444 1 8.2904 4.07274 7.4316 9.5379 25.3171 7.28976 +445 1 1.3832 3.4915 6.68441 -1.24784 -22.5622 2.29536 +446 1 2.09272 4.19927 6.89939 7.14914 10.3433 -0.646722 +447 1 2.38812 3.48925 7.75082 -1.53849 -4.15299 -0.56146 +448 1 0.98545 4.31304 7.66307 5.8465 7.34467 12.6645 +449 1 3.01955 3.30623 6.95327 13.2113 8.86686 7.49164 +450 1 4.09943 3.91395 7.09298 -2.48303 5.76893 1.33505 +451 1 4.01094 3.20608 7.89765 -2.70921 2.34384 1.12391 +452 1 3.37728 4.06259 7.97546 3.1883 6.31048 -16.9835 +453 1 4.95274 4.06193 6.44472 -50.262 -12.0969 -14.4258 +454 1 5.82886 4.19415 6.78586 51.8922 14.3443 21.8961 +455 1 5.38346 3.34165 7.34475 16.015 22.8896 8.36611 +456 1 5.08561 4.4601 7.63447 17.0994 -9.93497 -11.4722 +457 1 6.63523 3.51978 6.68288 11.156 -6.22589 -13.2585 +458 1 7.56324 4.26511 6.59456 -1.25309 2.63878 0.745103 +459 1 7.65852 3.28844 7.34661 -10.7372 -4.25374 3.64969 +460 1 6.81691 4.07739 7.53042 5.20496 31.087 -1.8792 +461 1 0.0305913 5.07954 6.63961 -13.4152 -0.334577 -15.0347 +462 1 0.755373 5.9128 6.63716 6.29428 -4.8245 9.83099 +463 1 0.228688 5.17338 7.63443 6.77209 -15.3569 2.77515 +464 1 0.0239769 6.1789 7.50959 5.71025 13.0173 8.45368 +465 1 1.62736 5.16876 6.26262 -1.95267 15.3222 16.2267 +466 1 2.58882 5.57631 6.81228 -21.3734 15.7914 -12.1527 +467 1 2.44828 4.86387 7.63128 0.635145 -14.9061 -0.714387 +468 1 1.59901 5.57209 7.51534 -11.1496 -3.28487 -5.03165 +469 1 3.34619 4.96263 7.08932 17.4571 -30.3367 -0.525226 +470 1 4.2543 5.71212 7.1129 9.72931 3.13017 -7.54215 +471 1 4.20945 4.90695 7.86069 -23.7666 -21.5851 -7.20856 +472 1 3.30097 5.87496 7.52978 -1.62077 18.6793 20.7743 +473 1 5.31869 5.1825 6.70313 -6.70115 -5.30598 20.424 +474 1 6.1285 5.9705 7.04356 -55.8752 -30.7828 -22.045 +475 1 6.19989 5.01385 7.64593 -24.2843 -27.8512 -0.0723503 +476 1 5.23737 5.71302 7.75618 7.88564 -2.82129 -5.95862 +477 1 6.57282 5.00818 6.64579 3.73801 7.56977 2.57742 +478 1 7.65968 6.07456 6.846 -10.6673 -6.72159 -16.2973 +479 1 7.41458 5.08419 7.34751 2.79575 -2.58892 1.26995 +480 1 6.72257 5.83109 7.80136 50.7146 16.6992 29.5346 +481 1 0.0723308 6.76891 6.47705 11.6111 8.10298 22.8191 +482 1 1.02933 7.74537 6.50218 -6.26193 -3.88943 1.15511 +483 1 0.947055 6.70337 7.58592 -5.51835 -14.0139 4.24362 +484 1 0.0848928 7.36532 7.45176 -1.87156 3.22591 1.0451 +485 1 1.56902 6.60766 6.76327 -14.013 -31.9293 15.0177 +486 1 2.40361 7.17234 6.95829 30.5527 12.991 8.35655 +487 1 2.29885 6.36291 7.58786 1.80834 5.53646 4.44151 +488 1 1.553 7.54602 7.43994 -8.27629 2.11355 -7.51923 +489 1 3.47111 6.73135 6.78593 -6.0772 1.66346 11.0677 +490 1 4.24975 7.49747 6.97664 2.8759 -9.15152 10.7243 +491 1 4.10179 6.68273 7.72108 -3.71491 1.8557 -11.1514 +492 1 3.18945 7.41445 7.81539 11.7129 -34.8369 22.2868 +493 1 5.09069 6.56162 6.92242 0.709322 1.72009 4.70344 +494 1 6.15914 7.53992 6.80488 -4.25562 -6.4834 8.29409 +495 1 6.17817 6.79535 7.72789 -19.4606 -0.130997 -26.8387 +496 1 5.10104 7.47088 7.65047 -2.76834 -2.47532 -11.4779 +497 1 6.74018 6.65599 6.74814 32.1985 25.9827 -14.7809 +498 1 7.41102 7.54832 6.72723 12.7336 -14.2037 26.5422 +499 1 7.28837 6.72521 7.66327 11.2322 2.95469 4.78999 +500 1 6.81386 7.67069 7.84231 -16.9841 5.08288 -4.95949 diff --git a/examples/mdi/dump.17Jun22.snapshot.driver.plugin.3 b/examples/mdi/dump.17Jun22.snapshot.driver.plugin.3 new file mode 100644 index 0000000000..d12d121e55 --- /dev/null +++ b/examples/mdi/dump.17Jun22.snapshot.driver.plugin.3 @@ -0,0 +1,2036 @@ +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +500 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +ITEM: ATOMS id type x y z f_2[1] f_2[2] f_2[3] +1 1 0 0 0 -1.06581e-14 -1.06581e-14 -1.09635e-14 +2 1 0.839798 0.839798 0 2.88658e-15 3.34455e-15 -9.76996e-15 +3 1 0.839798 0 0.839798 2.66454e-15 -1.05471e-14 4.56579e-15 +4 1 0 0.839798 0.839798 -1.15463e-14 2.88658e-15 3.44169e-15 +5 1 1.6796 0 0 -3.67761e-16 -1.06581e-14 -1.13243e-14 +6 1 2.51939 0.839798 0 -3.1225e-16 2.66454e-15 -9.76996e-15 +7 1 2.51939 0 0.839798 -7.00828e-16 -1.06581e-14 2.9976e-15 +8 1 1.6796 0.839798 0.839798 -4.3715e-16 3.10862e-15 3.1225e-15 +9 1 3.35919 0 0 1.31353e-14 -1.06581e-14 -1.06581e-14 +10 1 4.19899 0.839798 0 -2.24404e-14 2.66454e-15 -8.88178e-15 +11 1 4.19899 0 0.839798 -2.34118e-14 -8.88178e-15 2.55351e-15 +12 1 3.35919 0.839798 0.839798 1.37182e-14 3.10862e-15 4.23273e-15 +13 1 5.03879 0 0 3.19189e-16 -7.99361e-15 -7.10543e-15 +14 1 5.87859 0.839798 0 2.27665e-14 2.88658e-15 -7.99361e-15 +15 1 5.87859 0 0.839798 2.16702e-14 -7.99361e-15 2.66454e-15 +16 1 5.03879 0.839798 0.839798 -4.09395e-16 2.88658e-15 2.90046e-15 +17 1 6.71838 0 0 -3.10862e-15 -9.63118e-15 -9.96425e-15 +18 1 7.55818 0.839798 0 4.44089e-16 2.58127e-15 -9.10383e-15 +19 1 7.55818 0 0.839798 0 -1.02141e-14 3.21965e-15 +20 1 6.71838 0.839798 0.839798 -2.94209e-15 2.90046e-15 4.02456e-15 +21 1 0 1.6796 0 -1.15463e-14 0 -1.04361e-14 +22 1 0.839798 2.51939 0 3.10862e-15 -1.38778e-16 -9.76996e-15 +23 1 0.839798 1.6796 0.839798 2.33147e-15 2.22045e-16 3.34455e-15 +24 1 0 2.51939 0.839798 -1.06581e-14 -7.21645e-16 2.9976e-15 +25 1 1.6796 1.6796 0 -4.23273e-16 6.93889e-18 -8.88178e-15 +26 1 2.51939 2.51939 0 -2.19963e-15 -1.79717e-15 -1.06581e-14 +27 1 2.51939 1.6796 0.839798 -1.2837e-15 9.08995e-16 2.88658e-15 +28 1 1.6796 2.51939 0.839798 3.53884e-16 -2.0331e-15 2.88658e-15 +29 1 3.35919 1.6796 0 1.351e-14 1.45717e-16 -7.99361e-15 +30 1 4.19899 2.51939 0 -2.32314e-14 -1.85268e-15 -9.76996e-15 +31 1 4.19899 1.6796 0.839798 -2.24404e-14 -2.08167e-16 3.33067e-15 +32 1 3.35919 2.51939 0.839798 1.45925e-14 -1.36002e-15 3.33067e-15 +33 1 5.03879 1.6796 0 2.28983e-16 1.94289e-16 -7.99361e-15 +34 1 5.87859 2.51939 0 2.13649e-14 -1.6584e-15 -7.99361e-15 +35 1 5.87859 1.6796 0.839798 1.98383e-14 1.17961e-15 3.10862e-15 +36 1 5.03879 2.51939 0.839798 3.40006e-16 -2.80331e-15 2.88658e-15 +37 1 6.71838 1.6796 0 -2.88658e-15 -2.63678e-16 -8.99281e-15 +38 1 7.55818 2.51939 0 1.33227e-15 -1.33227e-15 -9.99201e-15 +39 1 7.55818 1.6796 0.839798 -8.04912e-16 1.94289e-16 3.33067e-15 +40 1 6.71838 2.51939 0.839798 -3.10862e-15 -1.66533e-15 3.56659e-15 +41 1 0 3.35919 0 -1.06581e-14 1.31006e-14 -1.04361e-14 +42 1 0.839798 4.19899 0 2.66454e-15 -2.23849e-14 -9.76996e-15 +43 1 0.839798 3.35919 0.839798 2.33147e-15 1.43774e-14 4.01068e-15 +44 1 0 4.19899 0.839798 -8.88178e-15 -2.32037e-14 2.55351e-15 +45 1 1.6796 3.35919 0 -7.97973e-16 1.48562e-14 -8.88178e-15 +46 1 2.51939 4.19899 0 -1.82493e-15 -2.33424e-14 -8.88178e-15 +47 1 2.51939 3.35919 0.839798 -5.06539e-16 1.51476e-14 3.55271e-15 +48 1 1.6796 4.19899 0.839798 -2.08167e-16 -2.40918e-14 3.33067e-15 +49 1 3.35919 3.35919 0 1.26912e-14 1.45509e-14 -7.99361e-15 +50 1 4.19899 4.19899 0 -2.29816e-14 -2.24265e-14 -6.21725e-15 +51 1 4.19899 3.35919 0.839798 -2.21004e-14 1.13937e-14 2.88658e-15 +52 1 3.35919 4.19899 0.839798 1.249e-14 -2.21975e-14 2.88658e-15 +53 1 5.03879 3.35919 0 5.55112e-17 1.14977e-14 -7.10543e-15 +54 1 5.87859 4.19899 0 2.22183e-14 -2.21628e-14 -6.21725e-15 +55 1 5.87859 3.35919 0.839798 2.14412e-14 1.27467e-14 2.88658e-15 +56 1 5.03879 4.19899 0.839798 -2.08167e-16 -2.11983e-14 3.10862e-15 +57 1 6.71838 3.35919 0 -3.38618e-15 1.34615e-14 -8.04912e-15 +58 1 7.55818 4.19899 0 8.88178e-16 -2.42029e-14 -7.10543e-15 +59 1 7.55818 3.35919 0.839798 1.66533e-16 1.40443e-14 3.10862e-15 +60 1 6.71838 4.19899 0.839798 -3.05311e-15 -2.40641e-14 2.45637e-15 +61 1 0 5.03879 0 -7.10543e-15 8.88178e-16 -8.21565e-15 +62 1 0.839798 5.87859 0 2.66454e-15 2.29816e-14 -7.10543e-15 +63 1 0.839798 5.03879 0.839798 2.55351e-15 -2.77556e-16 2.67841e-15 +64 1 0 5.87859 0.839798 -9.76996e-15 2.18159e-14 2.66454e-15 +65 1 1.6796 5.03879 0 1.38778e-16 -1.02002e-15 -7.10543e-15 +66 1 2.51939 5.87859 0 -1.9984e-15 2.1684e-14 -8.88178e-15 +67 1 2.51939 5.03879 0.839798 -1.72085e-15 3.81639e-16 3.10862e-15 +68 1 1.6796 5.87859 0.839798 -8.74301e-16 2.02824e-14 3.10862e-15 +69 1 3.35919 5.03879 0 1.09704e-14 -2.08167e-16 -7.10543e-15 +70 1 4.19899 5.87859 0 -2.29192e-14 2.19269e-14 -5.32907e-15 +71 1 4.19899 5.03879 0.839798 -1.95469e-14 -1.15186e-15 2.88658e-15 +72 1 3.35919 5.87859 0.839798 1.19973e-14 2.21143e-14 2.88658e-15 +73 1 5.03879 5.03879 0 1.73472e-16 7.14706e-16 -4.44089e-15 +74 1 5.87859 5.87859 0 2.18575e-14 2.20726e-14 -6.21725e-15 +75 1 5.87859 5.03879 0.839798 1.9415e-14 3.747e-16 2.88658e-15 +76 1 5.03879 5.87859 0.839798 -6.52256e-16 1.92069e-14 2.88658e-15 +77 1 6.71838 5.03879 0 -2.38698e-15 6.73073e-16 -8.21565e-15 +78 1 7.55818 5.87859 0 0 2.28706e-14 -8.43769e-15 +79 1 7.55818 5.03879 0.839798 1.11022e-16 1.44329e-15 2.498e-15 +80 1 6.71838 5.87859 0.839798 -2.94209e-15 2.15661e-14 2.45637e-15 +81 1 0 6.71838 0 -1.06581e-14 -3.77476e-15 -9.60343e-15 +82 1 0.839798 7.55818 0 2.44249e-15 7.91034e-16 -9.20097e-15 +83 1 0.839798 6.71838 0.839798 2.33147e-15 -2.83107e-15 3.80251e-15 +84 1 0 7.55818 0.839798 -8.88178e-15 -2.22045e-16 3.05311e-15 +85 1 1.6796 6.71838 0 -9.85323e-16 -1.60982e-15 -8.99281e-15 +86 1 2.51939 7.55818 0 -1.51268e-15 6.66134e-16 -1.02141e-14 +87 1 2.51939 6.71838 0.839798 -7.91034e-16 -2.83801e-15 3.56659e-15 +88 1 1.6796 7.55818 0.839798 2.08167e-16 2.77556e-16 3.33067e-15 +89 1 3.35919 6.71838 0 1.25455e-14 -2.10942e-15 -8.04912e-15 +90 1 4.19899 7.55818 0 -2.46123e-14 0 -7.99361e-15 +91 1 4.19899 6.71838 0.839798 -2.33563e-14 -4.89886e-15 2.45637e-15 +92 1 3.35919 7.55818 0.839798 1.30868e-14 8.88178e-16 2.88658e-15 +93 1 5.03879 6.71838 0 -3.60822e-16 -2.60902e-15 -7.32747e-15 +94 1 5.87859 7.55818 0 2.33424e-14 6.66134e-16 -7.99361e-15 +95 1 5.87859 6.71838 0.839798 2.1913e-14 -1.74166e-15 2.45637e-15 +96 1 5.03879 7.55818 0.839798 -2.08167e-16 -5.27356e-16 2.498e-15 +97 1 6.71838 6.71838 0 -2.83107e-15 -3.31679e-15 -7.10543e-15 +98 1 7.55818 7.55818 0 4.44089e-16 0 -8.88178e-15 +99 1 7.55818 6.71838 0.839798 5.55112e-17 -3.10862e-15 2.55351e-15 +100 1 6.71838 7.55818 0.839798 -2.88658e-15 5.27356e-16 2.56739e-15 +101 1 0 0 1.6796 -1.15463e-14 -1.04361e-14 -1.11022e-15 +102 1 0.839798 0.839798 1.6796 2.44249e-15 2.56739e-15 6.66134e-16 +103 1 0.839798 0 2.51939 2.66454e-15 -9.65894e-15 -1.20737e-15 +104 1 0 0.839798 2.51939 -1.15463e-14 2.55351e-15 -7.21645e-16 +105 1 1.6796 0 1.6796 1.73472e-16 -9.76996e-15 0 +106 1 2.51939 0.839798 1.6796 -1.71391e-15 2.66454e-15 3.88578e-16 +107 1 2.51939 0 2.51939 -1.15186e-15 -9.76996e-15 -1.33227e-15 +108 1 1.6796 0.839798 2.51939 5.55112e-17 3.33067e-15 -1.08247e-15 +109 1 3.35919 0 1.6796 1.41623e-14 -8.88178e-15 6.66134e-16 +110 1 4.19899 0.839798 1.6796 -2.18159e-14 2.44249e-15 -6.10623e-16 +111 1 4.19899 0 2.51939 -2.31204e-14 -7.10543e-15 -1.55431e-15 +112 1 3.35919 0.839798 2.51939 1.46272e-14 2.88658e-15 -6.80012e-16 +113 1 5.03879 0 1.6796 8.67362e-16 -8.88178e-15 8.88178e-16 +114 1 5.87859 0.839798 1.6796 2.02685e-14 2.44249e-15 1.02696e-15 +115 1 5.87859 0 2.51939 2.07057e-14 -7.10543e-15 -1.55431e-15 +116 1 5.03879 0.839798 2.51939 4.44089e-16 2.66454e-15 -1.4988e-15 +117 1 6.71838 0 1.6796 -2.52576e-15 -8.77076e-15 -9.02056e-17 +118 1 7.55818 0.839798 1.6796 3.747e-16 2.16493e-15 1.04083e-16 +119 1 7.55818 0 2.51939 -8.88178e-16 -1.02141e-14 -1.33227e-15 +120 1 6.71838 0.839798 2.51939 -2.88658e-15 2.90046e-15 -5.55112e-16 +121 1 0 1.6796 1.6796 -1.28786e-14 8.88178e-16 6.66134e-16 +122 1 0.839798 2.51939 1.6796 2.33147e-15 -1.43635e-15 1.11022e-16 +123 1 0.839798 1.6796 2.51939 2.44249e-15 3.88578e-16 -5.96745e-16 +124 1 0 2.51939 2.51939 -1.15463e-14 -1.16573e-15 -1.33227e-15 +125 1 1.6796 1.6796 1.6796 2.22045e-16 -1.67921e-15 5.96745e-16 +126 1 2.51939 2.51939 1.6796 -8.95117e-16 -2.39392e-15 -1.3739e-15 +127 1 2.51939 1.6796 2.51939 -8.88178e-16 -8.32667e-17 -8.88178e-16 +128 1 1.6796 2.51939 2.51939 3.46945e-16 -1.77636e-15 -8.88178e-16 +129 1 3.35919 1.6796 1.6796 1.44329e-14 -1.58207e-15 5.27356e-16 +130 1 4.19899 2.51939 1.6796 -2.17534e-14 -1.89432e-15 -4.85723e-16 +131 1 4.19899 1.6796 2.51939 -2.08722e-14 -1.94289e-16 -1.33227e-15 +132 1 3.35919 2.51939 2.51939 1.46133e-14 -1.55431e-15 -1.11022e-15 +133 1 5.03879 1.6796 1.6796 6.38378e-16 -4.78784e-16 8.46545e-16 +134 1 5.87859 2.51939 1.6796 2.05322e-14 -1.4086e-15 2.28983e-16 +135 1 5.87859 1.6796 2.51939 2.10942e-14 -3.33067e-16 -1.33227e-15 +136 1 5.03879 2.51939 2.51939 4.44089e-16 -2.22045e-15 -1.11022e-15 +137 1 6.71838 1.6796 1.6796 -2.16493e-15 -9.4369e-16 5.55112e-17 +138 1 7.55818 2.51939 1.6796 -4.44089e-16 -1.11022e-15 -2.77556e-17 +139 1 7.55818 1.6796 2.51939 2.22045e-16 1.17961e-15 -1.77636e-15 +140 1 6.71838 2.51939 2.51939 -3.10862e-15 -1.73472e-15 -1.52656e-15 +141 1 0 3.35919 1.6796 -1.11022e-14 1.39888e-14 -2.22045e-16 +142 1 0.839798 4.19899 1.6796 2.44249e-15 -2.1684e-14 -6.10623e-16 +143 1 0.839798 3.35919 2.51939 2.88658e-15 1.45162e-14 -5.82867e-16 +144 1 0 4.19899 2.51939 -8.88178e-15 -2.30926e-14 -1.55431e-15 +145 1 1.6796 3.35919 1.6796 2.08167e-16 1.37251e-14 5.41234e-16 +146 1 2.51939 4.19899 1.6796 -1.72778e-15 -2.28081e-14 -1.32533e-15 +147 1 2.51939 3.35919 2.51939 -1.55431e-15 1.44884e-14 -1.11022e-15 +148 1 1.6796 4.19899 2.51939 -2.22045e-16 -2.19824e-14 -1.33227e-15 +149 1 3.35919 3.35919 1.6796 1.39194e-14 1.31006e-14 3.46945e-16 +150 1 4.19899 4.19899 1.6796 -2.1684e-14 -2.2142e-14 -1.26982e-15 +151 1 4.19899 3.35919 2.51939 -2.22045e-14 1.13243e-14 -1.33227e-15 +152 1 3.35919 4.19899 2.51939 1.19904e-14 -2.35367e-14 -8.88178e-16 +153 1 5.03879 3.35919 1.6796 -6.93889e-18 1.12688e-14 1.38778e-16 +154 1 5.87859 4.19899 1.6796 2.0213e-14 -2.25167e-14 2.28983e-16 +155 1 5.87859 3.35919 2.51939 2.08722e-14 1.13798e-14 -1.55431e-15 +156 1 5.03879 4.19899 2.51939 2.08167e-16 -2.08722e-14 -1.55431e-15 +157 1 6.71838 3.35919 1.6796 -2.96291e-15 1.29619e-14 -1.11716e-15 +158 1 7.55818 4.19899 1.6796 2.22045e-16 -2.33147e-14 -4.996e-16 +159 1 7.55818 3.35919 2.51939 8.88178e-16 1.37113e-14 -1.9984e-15 +160 1 6.71838 4.19899 2.51939 -3.27516e-15 -2.45082e-14 -6.93889e-16 +161 1 0 5.03879 1.6796 -7.10543e-15 4.44089e-16 0 +162 1 0.839798 5.87859 1.6796 2.44249e-15 2.08375e-14 7.21645e-16 +163 1 0.839798 5.03879 2.51939 2.66454e-15 2.91434e-16 -2.13718e-15 +164 1 0 5.87859 2.51939 -8.88178e-15 2.11497e-14 -1.55431e-15 +165 1 1.6796 5.03879 1.6796 2.56739e-16 8.60423e-16 8.04912e-16 +166 1 2.51939 5.87859 1.6796 -9.64506e-16 2.08375e-14 -7.35523e-16 +167 1 2.51939 5.03879 2.51939 -1.33227e-15 2.22045e-16 -6.66134e-16 +168 1 1.6796 5.87859 2.51939 2.22045e-16 1.9984e-14 -8.88178e-16 +169 1 3.35919 5.03879 1.6796 1.12549e-14 2.08167e-17 1.08247e-15 +170 1 4.19899 5.87859 1.6796 -2.15591e-14 2.06987e-14 9.57567e-16 +171 1 4.19899 5.03879 2.51939 -1.93179e-14 4.44089e-16 -1.9984e-15 +172 1 3.35919 5.87859 2.51939 1.17545e-14 2.17604e-14 -1.77636e-15 +173 1 5.03879 5.03879 1.6796 2.77556e-17 -1.38778e-16 1.20737e-15 +174 1 5.87859 5.87859 1.6796 2.07542e-14 2.02408e-14 7.70217e-16 +175 1 5.87859 5.03879 2.51939 1.95399e-14 1.4988e-15 -1.55431e-15 +176 1 5.03879 5.87859 2.51939 6.80012e-16 1.88738e-14 -1.55431e-15 +177 1 6.71838 5.03879 1.6796 -2.42167e-15 -1.31839e-16 -3.33067e-16 +178 1 7.55818 5.87859 1.6796 -2.22045e-16 2.19824e-14 2.22045e-16 +179 1 7.55818 5.03879 2.51939 4.44089e-16 1.05471e-15 -1.9984e-15 +180 1 6.71838 5.87859 2.51939 -3.05311e-15 2.11914e-14 -1.249e-15 +181 1 0 6.71838 1.6796 -1.02141e-14 -2.88658e-15 -6.66134e-16 +182 1 0.839798 7.55818 1.6796 1.9984e-15 6.38378e-16 2.22045e-16 +183 1 0.839798 6.71838 2.51939 2.66454e-15 -2.27596e-15 -1.02696e-15 +184 1 0 7.55818 2.51939 -9.76996e-15 -6.66134e-16 -1.66533e-15 +185 1 1.6796 6.71838 1.6796 1.94289e-16 -2.31759e-15 1.249e-16 +186 1 2.51939 7.55818 1.6796 -1.249e-15 -6.17562e-16 5.55112e-17 +187 1 2.51939 6.71838 2.51939 -1.33227e-15 -2.44249e-15 -1.22125e-15 +188 1 1.6796 7.55818 2.51939 0 0 -1.77636e-15 +189 1 3.35919 6.71838 1.6796 1.34198e-14 -2.02616e-15 -6.245e-17 +190 1 4.19899 7.55818 1.6796 -2.38282e-14 -4.71845e-16 1.45717e-16 +191 1 4.19899 6.71838 2.51939 -2.34951e-14 -3.88578e-15 -1.44329e-15 +192 1 3.35919 7.55818 2.51939 1.28092e-14 4.44089e-16 -1.11022e-15 +193 1 5.03879 6.71838 1.6796 -6.245e-17 -1.65146e-15 2.35922e-16 +194 1 5.87859 7.55818 1.6796 2.23294e-14 1.13798e-15 -6.93889e-18 +195 1 5.87859 6.71838 2.51939 2.21628e-14 -3.16414e-15 -5.55112e-16 +196 1 5.03879 7.55818 2.51939 2.22045e-16 -4.44089e-16 -1.55431e-15 +197 1 6.71838 6.71838 1.6796 -2.62984e-15 -2.59515e-15 -1.47798e-15 +198 1 7.55818 7.55818 1.6796 4.44089e-16 2.22045e-16 -8.32667e-17 +199 1 7.55818 6.71838 2.51939 4.44089e-16 -3.02536e-15 -1.77636e-15 +200 1 6.71838 7.55818 2.51939 -2.10942e-15 3.46945e-16 -1.91513e-15 +201 1 0 0 3.35919 -9.76996e-15 -9.99201e-15 1.31006e-14 +202 1 0.839798 0.839798 3.35919 2.44249e-15 2.67841e-15 1.4877e-14 +203 1 0.839798 0 4.19899 2.66454e-15 -7.88258e-15 -2.24543e-14 +204 1 0 0.839798 4.19899 -8.88178e-15 2.66454e-15 -2.30371e-14 +205 1 1.6796 0 3.35919 -2.22045e-16 -1.06581e-14 1.44329e-14 +206 1 2.51939 0.839798 3.35919 -1.20737e-15 2.66454e-15 1.40998e-14 +207 1 2.51939 0 4.19899 -2.06085e-15 -7.99361e-15 -2.22045e-14 +208 1 1.6796 0.839798 4.19899 6.93889e-16 2.88658e-15 -1.99979e-14 +209 1 3.35919 0 3.35919 1.34892e-14 -1.06581e-14 1.37668e-14 +210 1 4.19899 0.839798 3.35919 -2.25583e-14 2.44249e-15 1.32117e-14 +211 1 4.19899 0 4.19899 -2.28151e-14 -4.44089e-15 -2.33147e-14 +212 1 3.35919 0.839798 4.19899 1.23998e-14 2.22045e-15 -2.1344e-14 +213 1 5.03879 0 3.35919 -2.35922e-16 -6.21725e-15 1.02141e-14 +214 1 5.87859 0.839798 3.35919 2.19616e-14 2.55351e-15 1.14353e-14 +215 1 5.87859 0 4.19899 2.16702e-14 -5.32907e-15 -2.30926e-14 +216 1 5.03879 0.839798 4.19899 -1.8735e-16 2.66454e-15 -2.00395e-14 +217 1 6.71838 0 3.35919 -2.83107e-15 -1.05471e-14 1.34059e-14 +218 1 7.55818 0.839798 3.35919 2.77556e-16 2.498e-15 1.32117e-14 +219 1 7.55818 0 4.19899 1.33227e-15 -6.66134e-15 -2.4869e-14 +220 1 6.71838 0.839798 4.19899 -3.44169e-15 2.45637e-15 -2.39253e-14 +221 1 0 1.6796 3.35919 -9.76996e-15 6.66134e-16 1.44329e-14 +222 1 0.839798 2.51939 3.35919 2.77556e-15 -9.29812e-16 1.40998e-14 +223 1 0.839798 1.6796 4.19899 2.44249e-15 5.27356e-16 -2.14967e-14 +224 1 0 2.51939 4.19899 -8.88178e-15 -2.33147e-15 -2.2371e-14 +225 1 1.6796 1.6796 3.35919 0 2.22045e-16 1.33227e-14 +226 1 2.51939 2.51939 3.35919 -1.66533e-15 -1.4988e-15 1.33227e-14 +227 1 2.51939 1.6796 4.19899 -1.5335e-15 -3.46945e-16 -2.19824e-14 +228 1 1.6796 2.51939 4.19899 3.60822e-16 -1.35308e-15 -2.08722e-14 +229 1 3.35919 1.6796 3.35919 1.37668e-14 -2.22045e-16 1.42109e-14 +230 1 4.19899 2.51939 3.35919 -2.2371e-14 -1.60982e-15 1.24345e-14 +231 1 4.19899 1.6796 4.19899 -2.20657e-14 2.63678e-16 -2.28706e-14 +232 1 3.35919 2.51939 4.19899 1.23304e-14 -1.90126e-15 -2.22045e-14 +233 1 5.03879 1.6796 3.35919 -2.22045e-16 2.22045e-16 1.06581e-14 +234 1 5.87859 2.51939 3.35919 2.12885e-14 -1.16573e-15 1.15463e-14 +235 1 5.87859 1.6796 4.19899 2.09346e-14 -2.98372e-16 -2.17604e-14 +236 1 5.03879 2.51939 4.19899 3.60822e-16 -2.30371e-15 -2.02061e-14 +237 1 6.71838 1.6796 3.35919 -3.04617e-15 4.44089e-16 1.35031e-14 +238 1 7.55818 2.51939 3.35919 2.22045e-16 -1.55431e-15 1.36557e-14 +239 1 7.55818 1.6796 4.19899 2.22045e-16 8.8124e-16 -2.30926e-14 +240 1 6.71838 2.51939 4.19899 -3.33067e-15 -2.10942e-15 -2.46053e-14 +241 1 0 3.35919 3.35919 -9.76996e-15 1.44329e-14 1.37668e-14 +242 1 0.839798 4.19899 3.35919 2.55351e-15 -2.24404e-14 1.32117e-14 +243 1 0.839798 3.35919 4.19899 2.22045e-15 1.24761e-14 -2.27873e-14 +244 1 0 4.19899 4.19899 -5.32907e-15 -2.2593e-14 -2.32037e-14 +245 1 1.6796 3.35919 3.35919 0 1.33227e-14 1.33227e-14 +246 1 2.51939 4.19899 3.35919 -1.72085e-15 -2.33147e-14 1.24345e-14 +247 1 2.51939 3.35919 4.19899 -1.76942e-15 1.27329e-14 -2.42029e-14 +248 1 1.6796 4.19899 4.19899 -2.15106e-16 -2.24959e-14 -2.19824e-14 +249 1 3.35919 3.35919 3.35919 1.31006e-14 1.33227e-14 1.33227e-14 +250 1 4.19899 4.19899 3.35919 -2.28706e-14 -2.32592e-14 9.76996e-15 +251 1 4.19899 3.35919 4.19899 -2.38282e-14 9.74221e-15 -2.24265e-14 +252 1 3.35919 4.19899 4.19899 9.94343e-15 -2.41474e-14 -2.28706e-14 +253 1 5.03879 3.35919 3.35919 -2.22045e-16 1.02141e-14 1.06581e-14 +254 1 5.87859 4.19899 3.35919 2.16493e-14 -2.30926e-14 9.76996e-15 +255 1 5.87859 3.35919 4.19899 2.09208e-14 1.00753e-14 -2.28706e-14 +256 1 5.03879 4.19899 4.19899 2.35922e-16 -2.09416e-14 -2.08722e-14 +257 1 6.71838 3.35919 3.35919 -2.98372e-15 1.35031e-14 1.26149e-14 +258 1 7.55818 4.19899 3.35919 2.22045e-16 -2.4647e-14 1.11022e-14 +259 1 7.55818 3.35919 4.19899 0 1.19071e-14 -2.44249e-14 +260 1 6.71838 4.19899 4.19899 -3.4972e-15 -2.49106e-14 -2.42306e-14 +261 1 0 5.03879 3.35919 -7.10543e-15 4.44089e-16 1.04361e-14 +262 1 0.839798 5.87859 3.35919 2.44249e-15 2.20865e-14 1.23235e-14 +263 1 0.839798 5.03879 4.19899 2.44249e-15 -1.249e-16 -2.1122e-14 +264 1 0 5.87859 4.19899 -5.32907e-15 2.17604e-14 -2.32037e-14 +265 1 1.6796 5.03879 3.35919 6.66134e-16 0 9.76996e-15 +266 1 2.51939 5.87859 3.35919 -1.58207e-15 2.15938e-14 1.15463e-14 +267 1 2.51939 5.03879 4.19899 -2.16493e-15 -1.17961e-16 -2.13163e-14 +268 1 1.6796 5.87859 4.19899 4.64906e-16 2.14204e-14 -2.19824e-14 +269 1 3.35919 5.03879 3.35919 1.04361e-14 -2.22045e-16 9.76996e-15 +270 1 4.19899 5.87859 3.35919 -2.30232e-14 2.12053e-14 9.76996e-15 +271 1 4.19899 5.03879 4.19899 -1.99354e-14 -4.44089e-16 -2.06501e-14 +272 1 3.35919 5.87859 4.19899 1.03945e-14 2.19894e-14 -2.30926e-14 +273 1 5.03879 5.03879 3.35919 4.44089e-16 2.22045e-16 7.10543e-15 +274 1 5.87859 5.87859 3.35919 2.21906e-14 2.12608e-14 9.76996e-15 +275 1 5.87859 5.03879 4.19899 1.80897e-14 8.32667e-16 -2.02061e-14 +276 1 5.03879 5.87859 4.19899 6.80012e-16 1.83881e-14 -1.9762e-14 +277 1 6.71838 5.03879 3.35919 -3.64986e-15 4.02456e-16 1.08386e-14 +278 1 7.55818 5.87859 3.35919 4.44089e-16 2.33147e-14 1.17684e-14 +279 1 7.55818 5.03879 4.19899 -8.88178e-16 1.33227e-15 -2.22045e-14 +280 1 6.71838 5.87859 4.19899 -3.10862e-15 2.10248e-14 -2.43555e-14 +281 1 0 6.71838 3.35919 -9.76996e-15 -1.11022e-15 1.31006e-14 +282 1 0.839798 7.55818 3.35919 2.44249e-15 3.88578e-16 1.32949e-14 +283 1 0.839798 6.71838 4.19899 2.44249e-15 -2.8727e-15 -2.42306e-14 +284 1 0 7.55818 4.19899 -6.21725e-15 -2.22045e-16 -2.44249e-14 +285 1 1.6796 6.71838 3.35919 0 -3.49026e-15 1.35031e-14 +286 1 2.51939 7.55818 3.35919 -1.49186e-15 4.996e-16 1.32117e-14 +287 1 2.51939 6.71838 4.19899 -1.20737e-15 -2.77556e-15 -2.40918e-14 +288 1 1.6796 7.55818 4.19899 -2.35922e-16 1.33227e-15 -2.39808e-14 +289 1 3.35919 6.71838 3.35919 1.28786e-14 -2.82413e-15 1.35031e-14 +290 1 4.19899 7.55818 3.35919 -2.52021e-14 0 1.06581e-14 +291 1 4.19899 6.71838 4.19899 -2.37033e-14 -4.27436e-15 -2.43416e-14 +292 1 3.35919 7.55818 4.19899 1.1241e-14 1.9984e-15 -2.4869e-14 +293 1 5.03879 6.71838 3.35919 2.22045e-16 -3.93435e-15 1.08386e-14 +294 1 5.87859 7.55818 3.35919 2.31204e-14 6.66134e-16 1.24345e-14 +295 1 5.87859 6.71838 4.19899 2.28359e-14 -3.05311e-15 -2.41196e-14 +296 1 5.03879 7.55818 4.19899 2.08167e-16 -2.22045e-16 -2.26485e-14 +297 1 6.71838 6.71838 3.35919 -3.42781e-15 -2.64372e-15 1.27953e-14 +298 1 7.55818 7.55818 3.35919 2.22045e-16 -4.44089e-16 1.32672e-14 +299 1 7.55818 6.71838 4.19899 -4.44089e-16 -2.88658e-15 -2.62013e-14 +300 1 6.71838 7.55818 4.19899 -2.66454e-15 6.93889e-17 -2.6118e-14 +301 1 0 0 5.03879 -7.99361e-15 -7.77156e-15 -2.22045e-16 +302 1 0.839798 0.839798 5.03879 2.33147e-15 2.45637e-15 -4.44089e-16 +303 1 0.839798 0 5.87859 2.66454e-15 -8.77076e-15 2.14273e-14 +304 1 0 0.839798 5.87859 -8.88178e-15 2.58127e-15 2.12053e-14 +305 1 1.6796 0 5.03879 -2.01228e-16 -8.88178e-15 -6.66134e-16 +306 1 2.51939 0.839798 5.03879 -1.38778e-15 2.55351e-15 2.498e-16 +307 1 2.51939 0 5.87859 -2.15106e-15 -8.88178e-15 2.13163e-14 +308 1 1.6796 0.839798 5.87859 2.91434e-16 2.66454e-15 1.96371e-14 +309 1 3.35919 0 5.03879 1.03181e-14 -7.10543e-15 2.22045e-16 +310 1 4.19899 0.839798 5.03879 -2.11844e-14 2.55351e-15 -3.60822e-16 +311 1 4.19899 0 5.87859 -2.28081e-14 -6.21725e-15 2.28706e-14 +312 1 3.35919 0.839798 5.87859 1.23929e-14 2.66454e-15 2.05391e-14 +313 1 5.03879 0 5.03879 -1.04083e-16 -4.44089e-15 2.22045e-16 +314 1 5.87859 0.839798 5.03879 1.89987e-14 2.66454e-15 2.30371e-15 +315 1 5.87859 0 5.87859 2.15661e-14 -6.21725e-15 2.35367e-14 +316 1 5.03879 0.839798 5.87859 -3.46945e-16 2.88658e-15 2.32453e-14 +317 1 6.71838 0 5.03879 -2.9976e-15 -6.16174e-15 3.05311e-16 +318 1 7.55818 0.839798 5.03879 -1.11022e-16 2.30371e-15 1.77636e-15 +319 1 7.55818 0 5.87859 4.44089e-16 -6.43929e-15 2.33147e-14 +320 1 6.71838 0.839798 5.87859 -2.05391e-15 2.67841e-15 2.29816e-14 +321 1 0 1.6796 5.03879 -7.99361e-15 -6.66134e-16 0 +322 1 0.839798 2.51939 5.03879 2.55351e-15 -1.27676e-15 -8.32667e-17 +323 1 0.839798 1.6796 5.87859 2.44249e-15 6.52256e-16 2.03448e-14 +324 1 0 2.51939 5.87859 -8.88178e-15 -1.249e-15 2.10942e-14 +325 1 1.6796 1.6796 5.03879 5.89806e-16 -3.53884e-16 5.55112e-17 +326 1 2.51939 2.51939 5.03879 -6.8695e-16 -1.79023e-15 -5.41234e-16 +327 1 2.51939 1.6796 5.87859 -9.4369e-16 6.93889e-17 2.04281e-14 +328 1 1.6796 2.51939 5.87859 1.66533e-16 -1.38778e-15 2.04281e-14 +329 1 3.35919 1.6796 5.03879 1.11647e-14 4.51028e-16 2.77556e-16 +330 1 4.19899 2.51939 5.03879 -1.98869e-14 -2.67841e-15 1.8735e-16 +331 1 4.19899 1.6796 5.87859 -2.1684e-14 -8.8124e-16 2.30926e-14 +332 1 3.35919 2.51939 5.87859 1.18516e-14 -1.68615e-15 2.04281e-14 +333 1 5.03879 1.6796 5.03879 1.17961e-16 -3.19189e-16 7.07767e-16 +334 1 5.87859 2.51939 5.03879 1.91305e-14 -2.23432e-15 1.08941e-15 +335 1 5.87859 1.6796 5.87859 2.09416e-14 -1.25594e-15 2.22045e-14 +336 1 5.03879 2.51939 5.87859 3.747e-16 -2.38698e-15 2.13163e-14 +337 1 6.71838 1.6796 5.03879 -2.76862e-15 -6.8695e-16 4.57967e-16 +338 1 7.55818 2.51939 5.03879 -1.33227e-15 -1.9984e-15 7.77156e-16 +339 1 7.55818 1.6796 5.87859 8.88178e-16 -9.08995e-16 2.17604e-14 +340 1 6.71838 2.51939 5.87859 -2.83107e-15 -2.10942e-15 2.1233e-14 +341 1 0 3.35919 5.03879 -8.88178e-15 1.02141e-14 -2.22045e-16 +342 1 0.839798 4.19899 5.03879 2.66454e-15 -2.09902e-14 -8.32667e-16 +343 1 0.839798 3.35919 5.87859 2.66454e-15 1.27676e-14 2.12885e-14 +344 1 0 4.19899 5.87859 -5.32907e-15 -2.28706e-14 2.26485e-14 +345 1 1.6796 3.35919 5.03879 -1.04083e-16 1.15533e-14 -2.77556e-16 +346 1 2.51939 4.19899 5.03879 -2.17881e-15 -2.12469e-14 -6.45317e-16 +347 1 2.51939 3.35919 5.87859 -1.54043e-15 1.19765e-14 2.04281e-14 +348 1 1.6796 4.19899 5.87859 -5.55112e-17 -2.124e-14 2.30926e-14 +349 1 3.35919 3.35919 5.03879 1.09981e-14 1.09149e-14 8.46545e-16 +350 1 4.19899 4.19899 5.03879 -2.04767e-14 -2.17465e-14 1.05471e-15 +351 1 4.19899 3.35919 5.87859 -2.328e-14 1.00475e-14 2.13163e-14 +352 1 3.35919 4.19899 5.87859 9.73527e-15 -2.23502e-14 2.39808e-14 +353 1 5.03879 3.35919 5.03879 7.84095e-16 7.38992e-15 9.4369e-16 +354 1 5.87859 4.19899 5.03879 1.9415e-14 -1.99146e-14 5.55112e-17 +355 1 5.87859 3.35919 5.87859 2.16632e-14 1.011e-14 2.04281e-14 +356 1 5.03879 4.19899 5.87859 -4.85723e-17 -2.07334e-14 2.04281e-14 +357 1 6.71838 3.35919 5.03879 -3.66374e-15 1.00406e-14 -1.66533e-16 +358 1 7.55818 4.19899 5.03879 -1.11022e-15 -2.24265e-14 -3.33067e-16 +359 1 7.55818 3.35919 5.87859 4.44089e-16 1.04916e-14 2.30926e-14 +360 1 6.71838 4.19899 5.87859 -3.05311e-15 -2.38282e-14 2.29955e-14 +361 1 0 5.03879 5.03879 -3.9968e-15 -4.44089e-16 -4.44089e-16 +362 1 0.839798 5.87859 5.03879 2.55351e-15 1.9186e-14 8.60423e-16 +363 1 0.839798 5.03879 5.87859 3.10862e-15 -4.57967e-16 2.21212e-14 +364 1 0 5.87859 5.87859 -6.21725e-15 2.17604e-14 2.30926e-14 +365 1 1.6796 5.03879 5.03879 2.35922e-16 1.11716e-15 -4.57967e-16 +366 1 2.51939 5.87859 5.03879 -2.11636e-15 1.82909e-14 3.26128e-16 +367 1 2.51939 5.03879 5.87859 -1.67921e-15 -1.07553e-15 2.13163e-14 +368 1 1.6796 5.87859 5.87859 -6.245e-17 2.15244e-14 2.22045e-14 +369 1 3.35919 5.03879 5.03879 7.50788e-15 5.41234e-16 7.49401e-16 +370 1 4.19899 5.87859 5.03879 -2.04697e-14 1.75832e-14 5.55112e-16 +371 1 4.19899 5.03879 5.87859 -2.01089e-14 -2.08167e-17 2.22045e-14 +372 1 3.35919 5.87859 5.87859 1.06234e-14 2.1691e-14 2.22045e-14 +373 1 5.03879 5.03879 5.03879 9.02056e-17 -1.31839e-16 4.02456e-16 +374 1 5.87859 5.87859 5.03879 1.93734e-14 1.92069e-14 -3.60822e-16 +375 1 5.87859 5.03879 5.87859 1.92554e-14 9.92262e-16 2.22045e-14 +376 1 5.03879 5.87859 5.87859 1.52656e-16 1.84505e-14 2.13163e-14 +377 1 6.71838 5.03879 5.03879 -3.13638e-15 -1.31839e-16 1.01308e-15 +378 1 7.55818 5.87859 5.03879 -1.55431e-15 2.06501e-14 3.33067e-16 +379 1 7.55818 5.03879 5.87859 0 5.55112e-16 2.37588e-14 +380 1 6.71838 5.87859 5.87859 -2.72005e-15 2.13163e-14 2.30926e-14 +381 1 0 6.71838 5.03879 -7.54952e-15 -4.21885e-15 2.22045e-16 +382 1 0.839798 7.55818 5.03879 2.22045e-15 4.71845e-16 1.02696e-15 +383 1 0.839798 6.71838 5.87859 2.66454e-15 -1.91513e-15 2.19685e-14 +384 1 0 7.55818 5.87859 -6.21725e-15 0 2.29261e-14 +385 1 1.6796 6.71838 5.03879 -3.40006e-16 -2.32453e-15 1.23512e-15 +386 1 2.51939 7.55818 5.03879 -1.17267e-15 5.55112e-17 7.77156e-16 +387 1 2.51939 6.71838 5.87859 -1.4086e-15 -2.88658e-15 2.19547e-14 +388 1 1.6796 7.55818 5.87859 -2.498e-16 1.33227e-15 2.17604e-14 +389 1 3.35919 6.71838 5.03879 1.0679e-14 -2.04697e-15 4.16334e-16 +390 1 4.19899 7.55818 5.03879 -2.28151e-14 -1.44329e-15 7.77156e-16 +391 1 4.19899 6.71838 5.87859 -2.36963e-14 -2.60902e-15 2.28706e-14 +392 1 3.35919 7.55818 5.87859 1.11022e-14 1.11022e-15 2.28706e-14 +393 1 5.03879 6.71838 5.03879 4.16334e-17 -2.57433e-15 2.35922e-16 +394 1 5.87859 7.55818 5.03879 2.08999e-14 1.66533e-16 8.88178e-16 +395 1 5.87859 6.71838 5.87859 2.26208e-14 -3.05311e-15 2.37588e-14 +396 1 5.03879 7.55818 5.87859 1.38778e-17 -6.66134e-16 2.35367e-14 +397 1 6.71838 6.71838 5.03879 -3.16414e-15 -3.36536e-15 9.57567e-16 +398 1 7.55818 7.55818 5.03879 -2.22045e-16 0 1.16573e-15 +399 1 7.55818 6.71838 5.87859 -8.88178e-16 -2.52576e-15 2.44249e-14 +400 1 6.71838 7.55818 5.87859 -2.94209e-15 -1.11022e-16 2.42029e-14 +401 1 0 0 6.71838 -1.06581e-14 -9.54792e-15 -3.77476e-15 +402 1 0.839798 0.839798 6.71838 2.55351e-15 2.56739e-15 -1.88738e-15 +403 1 0.839798 0 7.55818 2.77556e-15 -7.92422e-15 -7.21645e-16 +404 1 0 0.839798 7.55818 -7.99361e-15 2.34535e-15 -4.44089e-16 +405 1 1.6796 0 6.71838 2.01228e-16 -7.99361e-15 -3.10862e-15 +406 1 2.51939 0.839798 6.71838 -1.9082e-15 2.55351e-15 -2.38698e-15 +407 1 2.51939 0 7.55818 -2.76168e-15 -7.10543e-15 6.66134e-16 +408 1 1.6796 0.839798 7.55818 9.4369e-16 2.44249e-15 1.60982e-15 +409 1 3.35919 0 6.71838 1.26218e-14 -7.10543e-15 -3.33067e-15 +410 1 4.19899 0.839798 6.71838 -2.40016e-14 2.44249e-15 -4.60743e-15 +411 1 4.19899 0 7.55818 -2.46053e-14 -7.99361e-15 -6.66134e-16 +412 1 3.35919 0.839798 7.55818 1.35586e-14 2.33147e-15 1.4988e-15 +413 1 5.03879 0 6.71838 2.28983e-16 -7.10543e-15 -2.44249e-15 +414 1 5.87859 0.839798 6.71838 2.2142e-14 2.44249e-15 -1.72085e-15 +415 1 5.87859 0 7.55818 2.23987e-14 -6.21725e-15 -8.88178e-16 +416 1 5.03879 0.839798 7.55818 5.55112e-17 2.55351e-15 9.99201e-16 +417 1 6.71838 0 6.71838 -3.27516e-15 -6.99441e-15 -3.05311e-15 +418 1 7.55818 0.839798 6.71838 -1.66533e-15 2.498e-15 -2.72005e-15 +419 1 7.55818 0 7.55818 -4.44089e-16 -8.65974e-15 -8.88178e-16 +420 1 6.71838 0.839798 7.55818 -2.72005e-15 2.67841e-15 3.88578e-16 +421 1 0 1.6796 6.71838 -1.02141e-14 -4.44089e-16 -2.22045e-15 +422 1 0.839798 2.51939 6.71838 2.55351e-15 -5.34295e-16 -2.83107e-15 +423 1 0.839798 1.6796 7.55818 2.77556e-15 9.71445e-16 6.66134e-16 +424 1 0 2.51939 7.55818 -8.88178e-15 -3.19189e-15 6.66134e-16 +425 1 1.6796 1.6796 6.71838 2.01228e-16 -7.84095e-16 -2.22045e-15 +426 1 2.51939 2.51939 6.71838 -1.4086e-15 -1.0339e-15 -3.10862e-15 +427 1 2.51939 1.6796 7.55818 -1.69309e-15 5.55112e-16 1.00614e-15 +428 1 1.6796 2.51939 7.55818 1.38778e-16 -2.08167e-15 9.71445e-16 +429 1 3.35919 1.6796 6.71838 1.30798e-14 -2.77556e-17 -2.22045e-15 +430 1 4.19899 2.51939 6.71838 -2.37449e-14 -2.3731e-15 -3.55271e-15 +431 1 4.19899 1.6796 7.55818 -2.36061e-14 4.64906e-16 1.58901e-15 +432 1 3.35919 2.51939 7.55818 1.32186e-14 -1.98452e-15 8.04912e-16 +433 1 5.03879 1.6796 6.71838 6.93889e-18 -5.82867e-16 -2.44249e-15 +434 1 5.87859 2.51939 6.71838 2.19755e-14 -1.1241e-15 -2.88658e-15 +435 1 5.87859 1.6796 7.55818 2.19824e-14 1.52656e-16 1.33921e-15 +436 1 5.03879 2.51939 7.55818 3.60822e-16 -2.27596e-15 4.57967e-16 +437 1 6.71838 1.6796 6.71838 -2.22738e-15 -5.27356e-16 -3.81639e-15 +438 1 7.55818 2.51939 6.71838 2.22045e-16 -1.9984e-15 -3.4972e-15 +439 1 7.55818 1.6796 7.55818 8.88178e-16 -2.35922e-16 0 +440 1 6.71838 2.51939 7.55818 -2.60902e-15 -2.01228e-15 4.44089e-16 +441 1 0 3.35919 6.71838 -1.11022e-14 1.31006e-14 -2.88658e-15 +442 1 0.839798 4.19899 6.71838 2.44249e-15 -2.36616e-14 -5.05151e-15 +443 1 0.839798 3.35919 7.55818 2.88658e-15 1.46966e-14 7.77156e-16 +444 1 0 4.19899 7.55818 -7.10543e-15 -2.46053e-14 0 +445 1 1.6796 3.35919 6.71838 2.15106e-16 1.20945e-14 -2.66454e-15 +446 1 2.51939 4.19899 6.71838 -1.11022e-15 -2.38143e-14 -3.9968e-15 +447 1 2.51939 3.35919 7.55818 -2.15106e-15 1.34129e-14 1.06165e-15 +448 1 1.6796 4.19899 7.55818 -6.52256e-16 -2.34812e-14 1.60982e-15 +449 1 3.35919 3.35919 6.71838 1.28647e-14 1.21778e-14 -2.22045e-15 +450 1 4.19899 4.19899 6.71838 -2.43763e-14 -2.36269e-14 -4.88498e-15 +451 1 4.19899 3.35919 7.55818 -2.49245e-14 1.13312e-14 1.19349e-15 +452 1 3.35919 4.19899 7.55818 1.15463e-14 -2.40225e-14 7.70217e-16 +453 1 5.03879 3.35919 6.71838 -2.28983e-16 8.9373e-15 -2.66454e-15 +454 1 5.87859 4.19899 6.71838 2.27873e-14 -2.50147e-14 -4.21885e-15 +455 1 5.87859 3.35919 7.55818 2.2829e-14 1.14631e-14 1.83187e-15 +456 1 5.03879 4.19899 7.55818 1.38778e-17 -2.39531e-14 6.80012e-16 +457 1 6.71838 3.35919 6.71838 -3.02536e-15 1.20806e-14 -2.70617e-15 +458 1 7.55818 4.19899 6.71838 -2.22045e-16 -2.59792e-14 -2.77556e-15 +459 1 7.55818 3.35919 7.55818 -8.88178e-16 1.21153e-14 2.22045e-16 +460 1 6.71838 4.19899 7.55818 -2.16493e-15 -2.52437e-14 3.88578e-16 +461 1 0 5.03879 6.71838 -7.10543e-15 2.22045e-16 -3.33067e-15 +462 1 0.839798 5.87859 6.71838 2.44249e-15 2.24612e-14 -2.16493e-15 +463 1 0.839798 5.03879 7.55818 2.9976e-15 -1.249e-16 1.85962e-15 +464 1 0 5.87859 7.55818 -7.10543e-15 2.23849e-14 -8.88178e-16 +465 1 1.6796 5.03879 6.71838 4.44089e-16 -1.17267e-15 -1.9984e-15 +466 1 2.51939 5.87859 6.71838 -1.54043e-15 2.23085e-14 -1.9984e-15 +467 1 2.51939 5.03879 7.55818 -2.1233e-15 7.84095e-16 1.19349e-15 +468 1 1.6796 5.87859 7.55818 -4.30211e-16 2.3509e-14 -3.88578e-16 +469 1 3.35919 5.03879 6.71838 1.02141e-14 -1.30451e-15 -2.44249e-15 +470 1 4.19899 5.87859 6.71838 -2.44735e-14 2.14967e-14 -1.55431e-15 +471 1 4.19899 5.03879 7.55818 -2.32037e-14 9.02056e-16 9.02056e-16 +472 1 3.35919 5.87859 7.55818 1.19904e-14 2.31898e-14 5.48173e-16 +473 1 5.03879 5.03879 6.71838 -2.35922e-16 -1.02696e-15 -3.55271e-15 +474 1 5.87859 5.87859 6.71838 2.34326e-14 2.18228e-14 -2.22045e-15 +475 1 5.87859 5.03879 7.55818 2.17604e-14 -1.15186e-15 6.17562e-16 +476 1 5.03879 5.87859 7.55818 1.38778e-17 2.25098e-14 1.05471e-15 +477 1 6.71838 5.03879 6.71838 -3.3723e-15 -9.85323e-16 -2.48412e-15 +478 1 7.55818 5.87859 6.71838 -6.66134e-16 2.39808e-14 -3.33067e-15 +479 1 7.55818 5.03879 7.55818 -8.88178e-16 9.71445e-17 2.22045e-16 +480 1 6.71838 5.87859 7.55818 -2.66454e-15 2.39669e-14 -3.33067e-16 +481 1 0 6.71838 6.71838 -9.32587e-15 -3.9968e-15 -2.88658e-15 +482 1 0.839798 7.55818 6.71838 2.33147e-15 4.02456e-16 -3.4972e-15 +483 1 0.839798 6.71838 7.55818 2.55351e-15 -1.98452e-15 2.77556e-16 +484 1 0 7.55818 7.55818 -8.88178e-15 -8.88178e-16 -2.22045e-16 +485 1 1.6796 6.71838 6.71838 2.08167e-16 -2.94903e-15 -2.92821e-15 +486 1 2.51939 7.55818 6.71838 -1.55431e-15 -1.66533e-16 -3.44169e-15 +487 1 2.51939 6.71838 7.55818 -1.63758e-15 -2.72005e-15 3.88578e-16 +488 1 1.6796 7.55818 7.55818 -1.38778e-17 2.22045e-16 0 +489 1 3.35919 6.71838 6.71838 1.22125e-14 -3.47639e-15 -2.92821e-15 +490 1 4.19899 7.55818 6.71838 -2.56808e-14 -2.22045e-16 -2.88658e-15 +491 1 4.19899 6.71838 7.55818 -2.61319e-14 -3.55271e-15 1.44329e-15 +492 1 3.35919 7.55818 7.55818 1.26704e-14 8.88178e-16 -1.11022e-15 +493 1 5.03879 6.71838 6.71838 0 -4.05231e-15 -3.3723e-15 +494 1 5.87859 7.55818 6.71838 2.46678e-14 -9.4369e-16 -2.88658e-15 +495 1 5.87859 6.71838 7.55818 2.38698e-14 -3.66374e-15 4.44089e-16 +496 1 5.03879 7.55818 7.55818 -4.30211e-16 -2.22045e-16 2.22045e-16 +497 1 6.71838 6.71838 6.71838 -2.47025e-15 -3.11556e-15 -2.52576e-15 +498 1 7.55818 7.55818 6.71838 -2.22045e-16 -2.22045e-16 -2.9976e-15 +499 1 7.55818 6.71838 7.55818 0 -2.52576e-15 -4.44089e-16 +500 1 6.71838 7.55818 7.55818 -3.10862e-15 1.79023e-15 -2.22045e-16 +ITEM: TIMESTEP +100 +ITEM: NUMBER OF ATOMS +500 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +ITEM: ATOMS id type x y z f_2[1] f_2[2] f_2[3] +1 1 0.123071 8.38872 8.3161 -13.5034 12.7208 4.27264 +2 1 0.832093 0.789482 0.0260634 11.6405 -9.02308 5.27054 +3 1 0.829348 8.32295 0.847054 0.253685 2.42198 0.190462 +4 1 0.167866 0.883683 1.1203 3.78838 -17.5987 -23.5446 +5 1 1.84325 0.268983 0.0506746 -34.1939 -23.1747 -16.5239 +6 1 2.48966 1.02521 0.0150167 17.3336 21.4777 -8.17686 +7 1 2.69085 0.133161 0.584204 54.6376 -37.2919 -8.47938 +8 1 2.03129 0.673907 1.00581 -42.9604 37.8091 32.6152 +9 1 3.4644 0.135395 8.22513 6.66121 1.25052 1.24977 +10 1 4.03955 1.11148 8.14659 12.0412 -8.97859 6.48992 +11 1 4.19379 0.0448744 0.829139 -7.8302 -27.8417 -6.76025 +12 1 3.64841 0.913699 0.700293 -19.72 -1.80986 -1.25088 +13 1 4.95468 8.24864 0.0754237 1.84477 -0.530278 -6.08608 +14 1 5.56087 0.715896 7.89459 8.56765 -1.46102 11.0915 +15 1 5.88623 0.0411411 0.556827 1.26181 -8.5789 -11.0866 +16 1 4.92937 0.724638 0.812217 17.273 10.8714 -8.85433 +17 1 6.72739 8.38085 8.13417 -35.3805 -5.9515 28.6252 +18 1 7.72548 0.788736 0.0488514 2.00593 -21.6326 -29.6842 +19 1 7.72508 8.25409 0.930095 1.50566 4.42937 -3.62071 +20 1 6.80396 0.557293 0.840198 23.1381 -17.3706 0.134541 +21 1 0.229449 1.60533 8.39298 -14.4977 16.7962 1.07689 +22 1 0.832071 2.6454 0.0244343 3.40253 -11.2938 10.3532 +23 1 1.17502 1.54184 1.17348 -25.8959 -2.9461 -24.9151 +24 1 0.259004 2.30396 1.08005 -0.921709 -4.92947 -4.61717 +25 1 1.52612 1.69846 0.0790119 2.24081 -1.66091 4.11232 +26 1 2.32335 2.59169 0.0356063 -1.33192 -7.27448 11.4357 +27 1 2.47613 1.68798 0.866847 -6.11708 -1.09078 12.1273 +28 1 1.75964 2.46963 1.02161 -10.4242 6.62214 -9.26339 +29 1 3.18899 1.91192 0.152422 12.8306 -10.0239 -26.2805 +30 1 4.16606 2.56561 0.31819 6.19268 17.1047 -29.5908 +31 1 4.20679 1.77492 0.904599 6.39419 -20.2587 16.143 +32 1 3.29457 2.54016 0.942536 8.4707 7.62624 9.38928 +33 1 5.08962 1.70142 0.228194 -1.96985 -10.7878 -18.1781 +34 1 5.8401 2.50153 8.17919 2.2116 -4.35098 8.5453 +35 1 6.13077 1.14332 0.361455 -13.4767 12.4455 -5.6398 +36 1 5.21187 2.29543 1.04708 -21.2445 17.0192 -2.44157 +37 1 7.1904 2.12537 8.11861 -26.262 1.63538 -8.89421 +38 1 7.82272 2.3769 0.452291 6.46918 9.92036 10.2415 +39 1 7.65568 1.36632 0.837818 -8.61574 34.9087 15.0511 +40 1 6.63096 2.29607 0.833592 -3.02945 -9.31899 -38.2195 +41 1 0.0701224 3.26957 0.347776 -7.76983 -4.00147 -12.0182 +42 1 0.634247 4.2146 8.13102 5.69069 28.6823 19.9973 +43 1 0.89062 3.25892 1.01274 -8.90571 5.17288 9.1951 +44 1 8.35578 4.21333 0.756755 0.0651816 10.3427 6.16366 +45 1 1.59376 3.50824 0.337522 12.8481 -18.5931 -31.178 +46 1 2.63362 4.08805 -0.0117409 -13.6881 -31.4545 31.8377 +47 1 2.64545 3.44217 0.972182 1.32962 4.76915 -6.91838 +48 1 1.77157 4.31331 0.893182 6.24463 15.8362 30.2465 +49 1 3.30506 3.15734 -0.00281637 -4.50664 8.90697 10.0795 +50 1 4.20121 3.98351 8.24532 14.9588 -4.89636 4.16185 +51 1 4.14049 3.34001 1.03567 7.31744 -35.2634 -0.734077 +52 1 3.55633 4.09497 0.714486 -22.5487 2.59697 3.44603 +53 1 5.00488 3.2958 8.40544 4.72004 -3.7586 -0.0676635 +54 1 6.02419 4.38739 8.28472 2.63675 -3.85348 -7.36203 +55 1 5.82125 3.13701 0.812331 3.285 1.60137 -0.83853 +56 1 4.81191 4.1205 0.886429 26.0514 -19.7571 -10.6482 +57 1 6.37904 3.38462 8.29958 8.77859 5.40588 1.21659 +58 1 7.16155 4.27433 8.23885 -4.15514 -15.8519 20.8515 +59 1 7.46381 3.5222 0.62725 -6.50801 1.62892 11.1525 +60 1 6.52496 4.16064 0.796816 7.21171 -6.93074 -7.48151 +61 1 8.21062 5.02405 8.32529 2.06274 -1.43255 -7.09188 +62 1 0.856242 5.68027 8.15143 -7.33544 -9.25849 21.6195 +63 1 0.668812 5.05722 1.0253 10.4106 -11.6037 -16.0599 +64 1 0.100757 5.9519 0.987463 -8.02818 6.7945 -7.41084 +65 1 1.67634 4.74298 8.35528 -7.26839 1.52359 -11.0387 +66 1 2.38848 5.51086 0.107164 2.54651 6.03927 1.46743 +67 1 2.70757 4.93813 1.01132 -4.75577 -9.71554 1.13089 +68 1 1.3925 5.83052 0.707681 -1.14437 -6.44566 7.34655 +69 1 3.45574 4.66587 8.23291 4.73605 39.4767 5.5614 +70 1 4.43743 5.80479 0.164115 -6.64024 0.386075 1.78009 +71 1 4.2065 4.90669 0.741814 -23.5797 23.1046 -22.8102 +72 1 3.32112 5.74269 0.715517 7.3169 4.77905 3.84994 +73 1 5.16076 4.9557 8.31038 -10.6163 5.08193 1.86037 +74 1 5.94307 5.96922 0.174598 0.307423 -9.87615 -0.075099 +75 1 5.67998 4.99641 0.866467 -3.37502 0.387608 -1.06988 +76 1 5.10533 6.15466 0.974945 -0.684733 -17.9465 -18.2172 +77 1 6.66954 5.212 0.215572 3.55269 -19.7927 -9.30717 +78 1 7.63194 6.03007 0.0625005 22.452 -11.4487 -13.3981 +79 1 7.77987 5.15692 0.880268 -13.4303 3.64316 1.97115 +80 1 6.9443 6.00859 0.774386 -22.1564 -21.0173 44.3085 +81 1 0.211543 6.60981 0.114883 -6.22763 -3.96979 4.85396 +82 1 0.828363 7.71074 8.05758 6.57912 -12.175 1.18202 +83 1 0.8511 6.85772 1.00145 14.3344 -16.9148 6.86093 +84 1 0.108182 7.491 0.729711 -16.3275 13.3125 -2.16192 +85 1 1.32651 6.53754 8.31267 17.3977 32.295 0.779922 +86 1 2.45313 7.32438 0.161863 4.38219 8.94585 -15.0057 +87 1 2.22206 6.5101 0.817864 2.61276 2.64125 -0.96007 +88 1 1.71157 7.54558 0.836721 -10.8648 3.37169 8.49449 +89 1 3.33137 6.74361 0.251121 4.01956 -5.07144 -3.19134 +90 1 4.31785 7.3164 0.250439 -2.62105 14.0423 -19.3334 +91 1 4.11403 6.69271 1.01148 -3.23605 5.58393 9.21791 +92 1 3.25046 7.65301 0.863299 7.69366 -3.67127 3.31805 +93 1 5.15822 6.61638 8.39412 -15.5898 18.5262 -4.77657 +94 1 5.88176 7.47131 8.35911 1.25772 40.9097 -41.218 +95 1 5.8589 6.89406 0.716878 17.4729 -36.9167 60.1945 +96 1 5.1317 7.5805 0.887324 -15.4398 8.72154 0.622041 +97 1 6.7242 6.72984 0.126171 2.95649 13.978 -28.6002 +98 1 7.71076 7.70275 8.27387 -25.252 1.96163 47.723 +99 1 7.67756 6.66145 0.969756 13.165 19.6736 4.48693 +100 1 6.86126 7.61056 0.694229 -2.98636 3.99324 3.02821 +101 1 8.36607 8.27958 1.86716 -0.17632 -3.19355 -10.789 +102 1 0.956051 0.693329 1.82901 -1.1092 0.489919 9.03263 +103 1 0.677954 8.19357 2.69404 9.64796 -1.44576 4.92708 +104 1 8.40822 0.658358 2.57043 0.358989 35.1247 -30.1625 +105 1 1.59709 8.27384 1.6579 -3.48424 8.95256 3.83776 +106 1 2.60262 0.937274 1.91114 -6.85695 -44.4167 -8.16487 +107 1 2.77964 8.33738 2.42411 -9.97653 17.8509 12.2111 +108 1 1.80103 0.545423 2.70436 3.05773 -0.374817 -3.43865 +109 1 3.48439 0.0645578 1.59153 -12.2456 1.16104 1.511 +110 1 4.22306 0.908637 1.62246 8.21176 3.032 -1.28199 +111 1 4.10829 0.251535 2.42791 -11.6297 -7.60593 -5.50766 +112 1 3.3006 0.854758 2.76304 -19.992 -17.3193 -31.4497 +113 1 4.89013 8.37666 1.691 47.9119 57.0599 0.585594 +114 1 5.94061 0.477826 1.48406 -3.07899 1.88699 12.3275 +115 1 5.88048 0.35971 2.56281 -4.35157 -20.3865 4.17854 +116 1 4.9283 1.00358 2.55425 0.721177 -5.70224 -8.52683 +117 1 6.83323 8.16485 1.66012 -9.63203 10.6138 -6.53177 +118 1 7.60236 0.72315 1.6205 1.19764 -13.0731 15.2148 +119 1 7.46261 8.34785 2.50942 4.27014 7.86644 3.21827 +120 1 6.98477 1.01167 2.43863 -2.7077 -3.72405 10.5475 +121 1 0.201795 1.49879 1.91201 12.0746 15.4759 7.55997 +122 1 0.970651 2.5763 1.77546 9.10281 -9.21672 19.206 +123 1 1.00278 1.70354 2.64935 -4.86832 -2.32063 -12.0578 +124 1 0.220174 2.4694 2.59226 -6.06395 2.41662 -4.31274 +125 1 1.87438 1.66139 1.85364 0.0891009 8.26815 7.54904 +126 1 2.5634 2.61259 1.66324 -1.39613 -9.56029 15.7565 +127 1 2.67373 1.74855 2.48368 16.2507 26.3662 25.5413 +128 1 1.81271 2.51993 2.48462 -12.4635 -12.9481 6.24626 +129 1 3.34642 1.5174 1.55361 6.72778 19.0825 -4.097 +130 1 4.08393 2.3973 1.7811 -4.91883 6.9472 -7.45962 +131 1 3.95017 1.57032 2.47783 9.96822 8.42852 -4.63348 +132 1 3.54843 2.54548 2.73936 0.891724 -11.4891 -8.75214 +133 1 5.35058 1.38537 1.51823 -3.50731 -2.89085 5.66595 +134 1 6.023 2.29204 1.65213 -4.43652 -0.464129 22.1024 +135 1 5.94747 1.35093 2.39209 2.54676 22.9646 2.61125 +136 1 4.92685 2.18916 2.37644 10.4243 -2.12633 1.01963 +137 1 6.61187 1.36453 1.49274 0.221959 8.29598 -0.620687 +138 1 7.32473 2.28685 1.57865 28.4734 -28.9459 -8.73783 +139 1 7.72873 1.81047 2.35176 -1.00775 -9.06934 31.0045 +140 1 6.61584 2.21437 2.52479 7.01251 0.0677084 2.80218 +141 1 8.39022 3.27891 1.73012 3.49525 -5.17929 -4.65996 +142 1 0.854964 4.19407 1.69788 1.56946 -2.00702 1.06174 +143 1 0.997978 3.23715 2.67504 2.30643 5.8223 1.06858 +144 1 7.97382 3.9138 2.48815 10.0732 9.91828 -12.5132 +145 1 1.83784 3.47408 1.69517 -12.404 -3.21409 -2.66267 +146 1 2.61842 4.21682 1.90008 2.14748 0.059531 -3.785 +147 1 2.48603 3.26502 2.5249 16.8304 14.9965 0.171158 +148 1 1.68761 4.23907 2.52806 -1.01396 -4.72261 -0.795752 +149 1 3.40602 3.2813 1.85914 -16.1626 0.355927 -8.83409 +150 1 4.09906 4.10307 1.70079 5.35563 8.08157 -4.08084 +151 1 4.20252 3.30769 2.50236 16.5461 8.94662 0.427258 +152 1 3.52577 4.20363 2.52362 -12.9682 0.481811 23.6133 +153 1 5.11847 3.18122 1.75203 -10.5302 -5.4337 -0.263304 +154 1 5.84661 3.9209 1.56262 -0.517958 8.86577 8.63788 +155 1 5.86922 3.05768 2.56393 3.07392 -0.105811 -3.05554 +156 1 4.80787 4.20147 2.51562 -15.5306 -18.6016 6.98719 +157 1 6.75594 3.06184 1.51831 -23.9843 53.9056 5.35996 +158 1 7.37411 4.33015 1.50837 10.7935 -8.89263 2.38858 +159 1 7.49772 2.90887 2.46868 -6.63254 10.1343 -14.9923 +160 1 6.70853 3.86113 2.32478 1.28299 1.19192 -0.76331 +161 1 8.35107 4.97447 1.76826 -6.01727 -4.60108 12.0065 +162 1 0.812206 5.83167 1.72433 7.83055 6.4827 17.8655 +163 1 0.780537 4.91988 2.60048 6.34607 -5.57446 -13.8552 +164 1 8.22728 5.818 2.44166 16.0462 -1.57715 15.6299 +165 1 1.69572 5.11642 1.80574 -4.96566 -14.135 -5.31489 +166 1 2.43043 5.85297 1.63568 5.29915 -1.62077 5.85546 +167 1 2.57792 5.02783 2.65315 -4.52746 -19.2236 -8.91777 +168 1 1.53526 5.79854 2.60003 3.8059 -10.2938 -9.84612 +169 1 3.51815 5.02648 1.76532 -11.6984 -21.692 -35.1665 +170 1 4.20879 5.78771 1.44267 -4.45704 -9.43328 11.2812 +171 1 4.17986 5.08228 2.52246 26.037 -4.72131 -0.0794421 +172 1 3.28564 5.71935 2.4374 15.7539 34.931 2.27384 +173 1 4.77269 4.90482 1.56605 20.4715 8.53759 27.1606 +174 1 6.0822 5.98003 1.39493 -10.1112 -7.66907 2.17662 +175 1 5.55864 4.81486 2.32198 32.4427 -4.71792 -40.0608 +176 1 5.42317 5.8389 2.32907 -1.32862 11.7729 0.869635 +177 1 6.58632 5.00994 1.4228 1.50987 11.9718 7.91199 +178 1 7.40728 5.76017 1.85143 -17.7756 -1.69935 -20.7445 +179 1 7.43483 4.90248 2.50406 4.81208 -4.17509 -3.00519 +180 1 6.49032 6.25339 2.53785 -9.86939 -13.1275 -11.226 +181 1 8.38687 6.70803 1.84686 8.51598 2.67685 -7.76441 +182 1 0.82672 7.5809 1.8586 -8.65199 -8.55201 -6.88257 +183 1 0.798368 6.66179 2.58415 -9.89719 -0.151349 -9.60426 +184 1 8.09266 7.50342 2.71078 14.8523 -0.33865 -5.72558 +185 1 1.67226 6.92941 1.90638 3.68667 -6.81729 -3.8166 +186 1 2.44977 7.72472 1.67328 13.6121 -19.3583 -10.8323 +187 1 2.6005 7.00136 2.53195 -4.75836 -8.709 1.95523 +188 1 1.74762 7.69197 2.71318 -2.53247 4.05033 -0.19863 +189 1 3.12318 6.68472 1.56494 -10.4586 3.85751 -11.4518 +190 1 4.29009 7.65387 1.60791 -51.7416 -54.1223 -14.9832 +191 1 3.94907 6.70085 2.16915 18.0446 -8.10905 7.08373 +192 1 3.47208 7.58339 2.49347 14.5465 5.92984 -2.02778 +193 1 5.12563 6.77282 1.76131 -9.48863 14.4825 6.97263 +194 1 5.83539 7.62987 1.64588 8.72191 3.82062 7.16953 +195 1 5.76423 6.96836 2.55864 -5.64345 11.6948 11.2338 +196 1 4.77822 7.71547 2.51809 6.21883 -11.3323 9.13654 +197 1 6.63559 6.81418 1.65333 9.11964 14.1494 -8.37133 +198 1 7.61434 7.47455 1.72558 2.40335 0.461228 -6.0911 +199 1 7.4792 6.66861 2.39873 -2.80551 0.930229 8.6336 +200 1 6.74988 7.49855 2.51532 0.27108 -2.11137 5.23264 +201 1 8.33028 0.11458 3.36279 -16.5826 -29.3888 39.8482 +202 1 0.924222 0.663074 3.34599 -4.22349 8.71948 1.26084 +203 1 0.761543 8.18959 3.97906 2.12091 4.50677 4.24971 +204 1 8.33433 0.813163 4.20564 6.5007 1.52148 -0.192127 +205 1 1.76574 0.0375621 3.77071 17.3013 -16.3871 -16.9245 +206 1 2.61977 0.818953 3.52119 -23.2651 -2.55324 12.2346 +207 1 2.77562 0.0652161 4.44741 -11.8421 6.13727 -13.8855 +208 1 1.49199 0.761034 4.41597 -5.10709 15.0925 14.5126 +209 1 3.2179 8.34804 3.44668 5.27936 -7.50847 -1.90568 +210 1 3.9439 0.797129 3.52456 17.3728 2.18733 11.5361 +211 1 4.23279 0.116688 4.32559 -2.42219 -2.56552 -2.26636 +212 1 3.32804 0.997948 4.36883 1.65433 -5.54648 3.47818 +213 1 4.71275 0.120112 3.21294 23.362 4.56383 23.3458 +214 1 5.81093 1.04185 3.50642 -3.03834 -26.4106 -17.8435 +215 1 5.68877 0.288558 4.20831 -1.41276 -13.7346 9.5471 +216 1 5.01865 1.1392 4.32627 0.968145 -3.23051 -6.43149 +217 1 6.64793 8.39618 3.24984 2.09632 -4.36032 3.69009 +218 1 7.5883 0.965027 3.40354 -4.44096 -3.20185 -1.58139 +219 1 7.46506 8.38162 4.26807 1.21074 2.40143 -20.8016 +220 1 6.68567 0.729309 4.05423 9.00491 -0.0257829 7.04417 +221 1 0.0217051 1.65067 3.33296 -0.896942 -12.0422 -1.44038 +222 1 0.778955 2.33585 3.53158 8.17696 34.6193 -17.2054 +223 1 0.812105 1.63712 4.22741 2.15493 -21.1842 9.58449 +224 1 8.36402 2.71734 4.23224 9.90405 -0.180735 2.89262 +225 1 1.64503 1.55583 3.44456 9.91651 -2.24847 10.5707 +226 1 2.72789 2.60115 3.33289 -22.1633 -6.4618 14.3253 +227 1 2.53285 1.75288 4.15927 -11.2604 4.59027 8.59695 +228 1 1.59486 2.51559 4.29587 -0.634079 -19.903 20.3392 +229 1 3.26158 1.6458 3.43181 16.9482 17.4067 -1.31054 +230 1 4.49124 2.67296 3.29881 0.516577 8.93567 6.85853 +231 1 4.12441 1.76399 4.16025 -12.4119 -16.9863 20.8263 +232 1 3.58648 2.62356 4.12513 -11.0948 -0.0880381 2.09248 +233 1 4.62064 1.66433 3.30411 17.3359 -14.3916 -7.7698 +234 1 5.72203 2.02067 3.4449 -2.49843 31.6335 -13.0426 +235 1 6.15135 1.60495 4.33133 -9.75959 4.02084 8.19224 +236 1 5.04088 2.23941 4.27882 30.2001 -2.39587 -19.7025 +237 1 6.91779 1.8813 3.52264 3.96777 -26.054 4.41687 +238 1 7.81771 2.53776 3.353 -2.77684 -3.41763 12.6677 +239 1 7.78069 1.81171 4.34601 -52.3825 1.07947 -51.791 +240 1 6.66141 2.49312 4.62997 -6.69802 -0.0628228 -12.7191 +241 1 0.122629 3.46604 3.3479 -1.26446 -22.7991 -11.2332 +242 1 0.85888 4.22824 3.46647 2.79502 3.87933 -3.60293 +243 1 0.937247 3.40088 4.29114 -12.1658 -1.27655 -7.25993 +244 1 8.30307 4.19021 4.02192 -7.37977 10.0618 19.4199 +245 1 1.73804 3.18337 3.5685 -15.8464 9.26468 -37.1326 +246 1 2.58615 4.05913 3.19953 0.360202 14.7294 -1.16411 +247 1 2.55925 3.4674 4.05471 16.7959 -2.51521 13.6147 +248 1 1.75131 4.20697 4.04231 3.51698 -5.56503 7.27084 +249 1 3.44857 3.37138 3.44602 9.39764 18.3315 -14.5187 +250 1 4.30487 4.37452 3.51867 -0.743412 -11.0963 -4.3924 +251 1 4.41614 3.34547 4.13696 17.6233 7.57534 -14.2893 +252 1 3.32801 4.25542 4.08286 6.07649 -1.13934 3.22429 +253 1 5.63651 3.09553 3.631 -4.7187 3.44811 6.48572 +254 1 5.99275 4.08946 3.17209 -2.06613 -3.23888 -8.73239 +255 1 6.47603 3.67609 4.18744 -9.24013 0.891239 -0.0265923 +256 1 5.32989 4.17403 4.01248 -3.14576 -0.648453 6.26049 +257 1 6.72457 2.86539 3.51605 -3.69406 17.3565 -4.96963 +258 1 7.32281 3.76777 3.25105 -10.2265 -1.63605 18.2335 +259 1 7.4303 3.25631 4.3358 5.44768 7.87627 -9.74689 +260 1 6.66407 4.65396 3.76405 -6.96361 -4.18223 2.73914 +261 1 8.26711 4.8857 3.17584 6.51218 -0.295316 -2.27808 +262 1 0.649285 5.74933 3.20979 -12.9544 -9.12523 -13.313 +263 1 1.01858 5.10915 4.40565 1.04387 0.402418 -2.70019 +264 1 0.0855082 5.80312 4.16158 -11.0199 -7.09759 8.81305 +265 1 1.78399 4.97143 3.32025 -23.7199 7.54456 -3.60592 +266 1 2.55969 5.96317 3.12483 -8.84523 11.7944 16.8138 +267 1 2.653 5.05017 3.85074 -4.37713 4.79953 16.9312 +268 1 2.04667 5.9581 4.23583 -12.9689 -9.50066 -2.67062 +269 1 3.52568 5.09169 3.32195 -1.60301 -3.74832 -0.530875 +270 1 4.17719 5.92991 3.13207 5.79449 2.84869 4.98978 +271 1 4.69237 5.20087 4.04914 -22.9168 0.480558 19.5714 +272 1 3.49623 5.87284 4.08872 -22.1914 -19.7939 -11.835 +273 1 5.22134 4.9979 3.22696 -11.435 -2.89555 -13.2152 +274 1 5.65705 6.11892 3.42751 2.78011 1.11701 -3.25891 +275 1 5.76121 5.22134 4.03501 7.67556 -2.59727 25.3068 +276 1 4.95772 6.04539 4.58052 58.0203 8.0254 -45.1554 +277 1 6.4538 5.11955 2.78748 -4.74406 7.07146 5.73728 +278 1 7.21538 5.95413 3.16364 10.7768 -10.9442 6.36207 +279 1 7.51809 5.20099 3.85697 17.9797 5.14787 9.68311 +280 1 6.63903 5.76912 4.06379 2.12496 12.0521 4.75162 +281 1 8.12324 6.45888 3.3557 6.09728 0.195353 -8.64393 +282 1 0.462088 7.19726 3.46792 19.553 -0.0547515 -15.4409 +283 1 0.957118 6.33073 3.94731 10.4711 20.6934 10.8557 +284 1 8.31788 7.62476 4.18946 -15.5996 1.5203 27.0435 +285 1 1.621 6.60508 3.20723 21.3874 20.2704 9.57573 +286 1 2.43565 7.40381 3.575 -2.23423 10.7661 -7.60718 +287 1 2.75508 6.70843 4.26783 9.69215 -9.86312 8.63304 +288 1 1.4194 7.32943 4.0782 6.712 1.12768 -13.3449 +289 1 3.55435 6.77984 3.25216 -11.0849 -3.43265 4.44657 +290 1 4.09983 7.6717 3.40332 0.775894 2.91256 6.51607 +291 1 4.08342 6.6168 4.34423 8.99422 27.9061 4.38721 +292 1 3.36001 7.55781 4.25663 44.0502 4.81661 -43.4399 +293 1 4.74991 6.77738 3.51304 4.59094 -3.55683 -10.177 +294 1 5.77556 7.6737 3.71378 -0.245399 -1.3978 -0.93703 +295 1 5.90589 6.74801 4.34426 -3.316 -4.25196 -0.216303 +296 1 4.8074 7.40991 4.34207 4.23627 19.8452 -2.32284 +297 1 6.58813 6.85169 3.45364 -7.67639 -5.27403 -11.3349 +298 1 7.50241 7.47925 3.56723 2.18816 13.5038 -24.0989 +299 1 7.40344 6.62065 4.10638 -2.8935 -4.19323 5.51308 +300 1 6.75843 7.5046 4.25149 -20.47 8.43665 16.7865 +301 1 8.33167 8.36145 4.9892 0.225809 34.2346 -31.8957 +302 1 0.576342 0.867151 5.40959 24.5697 -12.6304 -33.2572 +303 1 0.763006 0.00458111 6.00676 12.4506 6.43147 -2.11226 +304 1 8.26499 0.860176 6.08382 -7.17683 -4.07129 -51.5552 +305 1 1.81244 8.0383 4.87052 -5.76863 7.26347 -9.86755 +306 1 2.53533 1.09902 5.19234 -3.16803 0.678291 -2.97003 +307 1 2.78135 0.403413 6.40689 -26.816 9.12488 -11.3363 +308 1 1.58905 0.651353 5.66283 7.03419 0.981612 1.76622 +309 1 3.32058 0.106866 5.32447 -0.932856 13.5857 14.9154 +310 1 4.27557 0.92435 5.10725 -6.99093 5.63655 -6.45098 +311 1 4.28959 0.280237 5.95961 -30.2191 -30.0316 -14.6333 +312 1 3.38904 1.26869 5.835 20.8336 -7.28254 -13.6106 +313 1 5.00946 8.32617 5.09801 -7.438 6.03549 0.926349 +314 1 5.92216 0.863628 5.14574 -0.277075 -6.34381 -3.05305 +315 1 5.73427 0.0193827 5.90902 4.17974 0.428592 2.11829 +316 1 4.94752 0.963499 5.95092 36.9682 12.4342 8.28196 +317 1 6.68007 0.0753806 5.17719 -6.21888 -0.275929 -7.94036 +318 1 7.59475 0.718477 4.99 5.56935 4.26124 12.8688 +319 1 7.48253 8.3166 5.84711 10.9136 10.2783 15.4989 +320 1 6.8326 0.897437 5.9487 8.18452 -13.9005 5.8213 +321 1 0.0760609 1.64664 4.96296 26.1716 -2.70613 34.3225 +322 1 0.685552 2.56455 5.03633 12.0035 4.84556 -15.2829 +323 1 0.606729 1.82267 5.82598 7.27963 -3.46786 12.0617 +324 1 8.3293 2.58271 5.72712 2.9601 13.0212 32.1025 +325 1 1.39999 1.70565 5.12122 8.3487 -4.09076 2.04128 +326 1 2.73507 2.85653 4.90403 -0.345779 -0.804973 -4.73226 +327 1 2.41817 2.24309 5.70209 1.42091 -4.90412 -0.964796 +328 1 1.38108 2.54746 5.86585 12.2906 4.17611 0.525771 +329 1 3.33731 1.91289 4.90293 0.0185627 0.794978 8.4213 +330 1 4.3973 2.60866 4.92615 -15.1153 4.67891 22.5372 +331 1 4.2225 2.0218 5.81106 18.0418 -47.4422 -19.4137 +332 1 3.4994 2.65878 5.66207 -24.6152 28.1329 2.91513 +333 1 5.20081 1.64695 5.25699 -1.61968 25.0354 -10.6249 +334 1 5.90254 2.56674 5.38347 4.70787 3.18361 -12.95 +335 1 6.08989 1.61464 5.89214 -10.9271 -1.55847 2.77666 +336 1 5.02754 2.69198 5.87273 -13.869 2.1523 1.52243 +337 1 6.90208 1.46146 5.07178 -10.118 15.4867 -8.4201 +338 1 7.58477 2.54489 5.07036 0.223295 2.60985 -3.71518 +339 1 7.69807 1.70404 5.74305 2.65747 -7.01835 5.70621 +340 1 6.83671 2.31874 5.77518 8.75763 5.85965 2.81961 +341 1 8.33535 3.4475 5.0472 4.04483 5.65066 -3.26522 +342 1 0.908217 4.16423 5.06292 -2.0575 1.13184 -0.501506 +343 1 0.771491 3.42595 5.87741 5.33449 1.31478 -10.6197 +344 1 0.14652 4.33584 6.04676 1.00462 -8.1578 -20.2597 +345 1 1.77294 3.51463 4.93957 -1.27898 -7.63546 3.32247 +346 1 2.71396 3.96357 4.97834 15.9141 3.79204 10.1307 +347 1 2.46159 3.38803 6.16546 -1.0491 -20.8555 -15.9327 +348 1 1.72608 4.39112 6.04032 -15.046 -11.018 -10.0045 +349 1 3.71274 3.40467 4.85974 -22.3519 13.9348 10.8973 +350 1 4.57553 4.21697 4.87404 -3.96399 7.00234 -1.98713 +351 1 4.366 3.53193 5.70269 7.89254 -3.17347 6.37497 +352 1 3.55123 4.20329 5.82208 -22.8323 -11.992 0.86056 +353 1 5.31479 3.43328 4.96004 -12.842 -18.3451 -4.95866 +354 1 5.96487 4.21664 4.98586 3.26728 12.2832 1.14917 +355 1 5.67633 3.58987 5.96581 6.91479 -13.8012 -0.0730494 +356 1 5.15168 4.48521 5.88819 -0.135174 -6.62981 7.61527 +357 1 6.76571 3.37692 5.24691 -14.8051 -2.47074 -4.50431 +358 1 7.42413 4.19524 5.01259 2.27671 4.46784 -0.576517 +359 1 7.6092 3.42318 5.84837 11.8264 -15.8262 -18.7291 +360 1 6.54398 4.29611 5.89957 10.509 -8.9195 -1.16059 +361 1 0.0247094 4.83566 4.99938 1.36656 0.603431 -2.15766 +362 1 0.966205 6.14847 4.9405 -1.84638 -2.56131 10.6129 +363 1 1.10739 5.11215 5.5368 -2.77114 7.32267 -6.17701 +364 1 0.221311 5.77966 5.62316 -16.3542 -5.99991 -34.5248 +365 1 2.09075 4.80339 4.88071 -15.5377 1.88455 -3.51044 +366 1 2.76626 5.59872 5.00497 -13.1053 -0.333159 -40.3797 +367 1 2.60002 4.95633 5.81939 -13.3057 -3.60712 -16.1699 +368 1 1.73302 6.11974 5.67311 7.80367 -13.5214 9.39307 +369 1 3.69174 5.11983 4.8182 4.27828 -13.6521 -3.16237 +370 1 4.24517 5.95869 5.19837 -53.2876 -10.1225 40.5156 +371 1 4.22774 4.94663 5.7496 8.19104 22.5118 -1.663 +372 1 3.1136 6.02947 5.80151 37.6339 -12.4217 36.265 +373 1 5.23537 5.12533 5.07481 2.14794 5.35663 -5.58383 +374 1 5.80775 6.19434 5.36474 -12.1517 -18.4331 -19.8184 +375 1 5.9697 5.18437 6.0003 -7.47906 6.99384 0.912527 +376 1 4.94854 5.8692 5.99559 17.5377 -1.26338 -12.9619 +377 1 6.59757 5.09144 5.08104 3.06742 4.08464 -2.92894 +378 1 7.54367 5.98613 4.88573 -14.2361 -23.7654 7.79426 +379 1 7.60847 5.23322 5.63185 -1.35187 -6.94343 4.2911 +380 1 6.70769 5.94816 5.81677 14.1283 2.13907 3.81564 +381 1 8.22278 6.71702 5.01662 22.4316 17.1972 -3.51396 +382 1 0.869349 7.28869 4.96667 -10.0366 3.62496 3.89926 +383 1 0.896793 6.73687 5.91431 -6.40765 3.74255 3.0528 +384 1 0.0890555 7.7054 5.6706 -5.18167 -47.9244 34.8448 +385 1 1.8751 6.88564 4.94229 0.477268 -2.00274 -5.71819 +386 1 2.7587 7.55291 4.99872 -36.0591 6.05211 43.0833 +387 1 2.53846 6.82983 5.7787 -13.9577 26.1772 12.6196 +388 1 1.63934 7.57104 5.79621 -1.51722 -4.07644 10.4552 +389 1 3.46612 6.83867 5.20388 -3.25728 -8.15264 -25.1259 +390 1 4.01792 7.77747 5.13143 8.22604 -9.98488 -11.0207 +391 1 4.0616 6.71165 5.99374 37.4635 -34.7522 2.57336 +392 1 3.49035 7.48383 6.06615 -52.3442 43.3465 -6.60384 +393 1 4.82693 6.8523 5.20763 2.69445 10.0085 20.3981 +394 1 5.83663 7.67662 4.94011 2.65651 0.782445 -0.458959 +395 1 5.60118 6.903 6.05259 0.51238 5.45548 -5.22943 +396 1 4.49984 7.67391 6.05154 31.0401 -0.647522 -9.371 +397 1 6.56806 6.92617 5.22736 4.49918 -20.7724 -24.6194 +398 1 7.45007 7.68748 5.02454 6.13987 -21.0163 7.77973 +399 1 7.49751 6.80367 5.78308 -9.98894 13.1501 -5.7166 +400 1 6.63057 7.61754 5.92417 0.0687578 21.3795 23.8905 +401 1 8.32557 8.34894 6.68981 0.104638 -13.8897 -9.6087 +402 1 0.744366 0.980723 6.48852 -5.23114 -31.7269 30.0044 +403 1 1.21108 0.262565 7.55604 -5.48851 -4.18087 -6.76609 +404 1 8.40118 0.701811 7.40569 17.4537 3.62996 11.6339 +405 1 1.79336 8.32699 6.64062 -5.93242 0.737609 -0.84307 +406 1 2.60519 1.4776 6.42908 -42.7477 -20.3947 10.8513 +407 1 2.68468 8.32969 7.50367 2.82039 -8.74718 0.911275 +408 1 2.14004 0.776947 7.26895 -3.65906 16.1309 -1.11008 +409 1 3.6569 0.0715803 6.70451 13.9675 -20.3473 29.1568 +410 1 3.94985 1.1248 6.78323 8.0083 0.919865 -1.94163 +411 1 4.44955 0.15543 7.5921 -15.5929 3.09145 7.2634 +412 1 3.18676 1.19789 7.55079 30.4701 -36.3009 -8.08868 +413 1 5.10396 0.131358 6.81912 -7.97923 37.9971 -21.1894 +414 1 5.81993 0.996314 6.79068 7.76858 -21.7284 -2.73997 +415 1 5.80025 8.18188 7.49322 12.3507 -13.1302 8.70784 +416 1 4.85408 1.28227 7.42764 -12.4579 -6.47968 -9.5274 +417 1 6.58875 0.130914 6.74241 2.12753 -2.2097 0.634037 +418 1 7.59964 0.676617 6.71682 -68.3673 2.07925 42.2066 +419 1 7.52212 0.0593286 7.5834 32.5631 3.04014 -28.8024 +420 1 6.85279 0.923554 7.57208 -4.28539 1.49265 -2.17621 +421 1 8.34941 1.72633 6.6429 -6.24486 10.7883 12.2426 +422 1 0.752277 2.47155 6.72526 -3.9412 -10.7788 3.00465 +423 1 0.813192 1.63555 7.42993 -7.74314 -11.2011 -0.638694 +424 1 8.22443 2.54813 7.66732 2.56273 -1.56785 0.82339 +425 1 1.49636 1.56107 6.38447 44.5625 33.4582 -3.13704 +426 1 2.30525 2.475 6.76961 -5.35408 6.54562 -0.949005 +427 1 2.49056 1.84724 7.59513 -61.407 9.30511 10.8314 +428 1 1.49273 2.39823 7.65033 13.5773 11.0727 -11.0854 +429 1 3.37689 2.03992 6.64219 17.5424 18.1797 1.52712 +430 1 4.36556 2.35363 6.72974 2.65202 20.8248 17.9478 +431 1 3.99822 2.02063 7.6547 18.3091 -10.0739 6.1027 +432 1 3.17328 2.55424 7.53823 -10.8617 31.8229 -4.73645 +433 1 5.21112 1.76508 6.50479 -18.4173 6.52495 3.64931 +434 1 5.87572 2.50861 6.47972 17.6588 16.4017 11.3405 +435 1 6.13161 1.75643 7.42519 -6.35346 6.11936 8.80778 +436 1 5.08243 2.27965 7.49559 3.10695 14.763 0.591819 +437 1 6.90515 1.73737 6.69685 6.36969 -4.89015 -2.67266 +438 1 7.59965 2.63279 6.71489 9.55617 -0.301288 -8.47778 +439 1 7.76189 1.52013 7.52701 3.93719 -1.66085 -6.19761 +440 1 6.70724 2.6779 7.2598 -8.99322 4.2321 11.9078 +441 1 0.125444 3.31521 6.66881 -20.5423 -11.9528 1.08126 +442 1 0.364694 4.22273 7.06 15.4688 8.78987 -5.27721 +443 1 0.60791 3.34758 7.65433 9.81501 -30.9601 -14.2913 +444 1 8.0984 3.85412 7.73406 0.295867 21.4592 0.238003 +445 1 1.38869 3.28611 6.86269 8.50148 8.2104 -0.813622 +446 1 2.52476 4.25334 6.66316 13.9982 13.4488 20.9739 +447 1 2.34408 3.26799 7.64808 -1.14502 9.26403 -10.1755 +448 1 1.45935 4.43411 7.31503 0.0272838 -0.538431 -2.52173 +449 1 3.66593 3.34626 6.65797 -1.50742 -4.19973 -15.7128 +450 1 4.32339 4.28741 6.63848 -1.71153 0.00989822 -0.270268 +451 1 4.03917 3.1404 7.61252 24.7136 -10.2891 3.12208 +452 1 3.36907 3.93473 7.50701 -10.481 -0.383957 -6.9951 +453 1 4.88527 3.3354 6.73465 -0.250758 1.18323 3.20962 +454 1 5.86197 4.30684 6.74144 -6.02175 10.4775 -12.9313 +455 1 5.83143 3.4729 7.33725 -5.24712 -23.3614 7.27214 +456 1 5.04517 4.19893 7.47372 14.0277 -13.7659 1.86079 +457 1 6.67093 3.19494 6.32389 -1.08882 16.2366 5.3564 +458 1 7.58567 3.93824 6.68879 13.8607 17.9546 17.9945 +459 1 7.41034 3.22296 8.01852 -22.7502 -28.7124 0.282368 +460 1 6.74041 3.98357 7.25541 -1.38378 3.03134 11.4432 +461 1 8.11164 5.05821 6.64701 -10.3621 4.23498 3.48281 +462 1 0.434229 5.95598 6.55583 13.6324 -1.56553 39.6492 +463 1 0.429061 5.17903 7.41995 -0.29478 -7.71855 -15.5486 +464 1 8.09598 5.94892 7.38464 -0.670206 -2.17368 6.38869 +465 1 1.41611 5.29567 6.55129 0.191903 6.07763 6.12613 +466 1 2.44376 5.87825 6.63669 -4.18767 0.226771 1.1996 +467 1 2.57445 4.71437 7.62895 -9.06207 26.6712 -23.195 +468 1 1.76163 5.67875 7.56712 4.16416 -0.382203 -1.94173 +469 1 3.23562 5.1121 6.55719 20.8924 -0.347412 22.4145 +470 1 4.05367 5.80831 6.49809 -13.6658 -13.8236 9.34588 +471 1 4.3499 4.91428 7.57309 -17.8958 19.2373 1.53594 +472 1 3.33848 5.81136 8.0112 0.629066 -2.48199 -2.55986 +473 1 5.22933 5.24678 6.83002 -9.21161 -10.3226 -4.65561 +474 1 5.87231 6.12998 6.73434 -14.492 -21.708 -7.10976 +475 1 6.102 5.06631 7.42095 8.16162 7.57706 8.09799 +476 1 5.11386 5.85851 7.69037 1.37823 -1.01778 -7.91082 +477 1 6.94866 5.10876 6.52261 -0.00645701 0.734687 4.76591 +478 1 7.67078 6.01392 6.41167 -4.02477 -14.728 2.57416 +479 1 7.35061 4.96205 7.5433 24.0095 -18.1944 -20.4412 +480 1 6.9284 5.83495 7.63045 -18.4707 37.5628 2.3937 +481 1 8.28984 6.85999 6.50497 12.0319 11.2505 5.01489 +482 1 0.775248 7.71516 6.80461 7.24585 -11.6558 8.08417 +483 1 0.533688 6.7762 7.54365 3.89137 -4.31915 -15.8578 +484 1 8.2465 7.61079 7.46416 25.9419 0.696332 -26.8887 +485 1 1.73177 6.71435 6.78434 -8.61422 -0.737705 -7.23833 +486 1 2.48272 7.50206 6.80041 12.0152 -3.31551 -7.82219 +487 1 2.37093 6.72113 7.64339 9.62293 -9.48685 2.94166 +488 1 1.77272 7.59226 7.58949 -2.97267 7.70343 0.621675 +489 1 3.29197 6.66554 6.74519 -6.55378 -4.76021 6.1499 +490 1 4.04728 7.44441 6.9325 9.38301 -4.09453 15.5296 +491 1 4.12674 6.55075 7.78018 3.09461 4.03017 -1.80654 +492 1 3.3807 7.43243 7.7243 -9.78058 -0.600287 9.7772 +493 1 4.74428 6.55735 6.78071 12.1641 10.0813 15.0085 +494 1 5.30209 7.56833 6.75011 8.90694 -20.2013 0.20059 +495 1 5.88783 6.83008 7.50111 -3.28565 3.55282 5.18781 +496 1 4.85536 7.429 7.66393 -0.8844 -0.824359 14.1315 +497 1 6.78323 6.58213 6.75112 16.4005 10.5566 0.00129152 +498 1 7.49771 7.53891 6.69245 -0.0692693 6.11315 -11.5276 +499 1 7.61589 6.80831 7.76686 -5.70997 -4.77696 -9.529 +500 1 6.80731 7.4637 7.45575 -10.489 5.43873 12.05 +ITEM: TIMESTEP +200 +ITEM: NUMBER OF ATOMS +500 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +ITEM: ATOMS id type x y z f_2[1] f_2[2] f_2[3] +1 1 8.41242 8.26599 8.38785 -10.0358 6.58437 5.2801 +2 1 0.814162 0.710931 0.0523899 -37.3452 31.5986 3.80166 +3 1 0.707188 8.3394 0.783901 7.22527 -6.84977 10.4166 +4 1 0.078844 0.75192 1.11978 38.2878 -8.01586 -1.83777 +5 1 1.52052 0.0613493 8.33894 50.642 -18.5757 54.2409 +6 1 2.63022 0.777198 -0.0136511 -14.6872 26.2087 -8.24369 +7 1 2.86573 8.3667 0.519039 4.98442 -20.5506 12.9041 +8 1 1.4757 0.711348 0.992341 22.4024 -8.05229 -33.8354 +9 1 3.79318 8.20698 8.14977 -12.6173 11.8638 7.05406 +10 1 4.0381 1.06879 8.36154 -11.3644 -3.77089 -31.1235 +11 1 3.94622 0.00241404 0.83531 3.0713 5.57971 3.39388 +12 1 3.2904 1.19609 0.697286 11.5663 -9.90219 11.4209 +13 1 4.80931 8.28217 0.152557 1.5084 -10.3853 -19.3359 +14 1 5.59181 0.724855 8.1093 -26.5323 12.4899 -7.60558 +15 1 5.68752 0.120676 0.713607 11.3113 1.42738 1.49966 +16 1 4.78554 0.81043 0.585131 26.0655 -22.1296 9.76004 +17 1 6.43613 0.237453 8.26775 30.1844 -14.2258 6.08634 +18 1 7.5043 0.643436 0.0691857 2.69659 0.617275 -0.831401 +19 1 7.7682 0.0476766 1.0238 2.88283 -8.74262 5.4154 +20 1 6.83111 0.459822 0.931748 -10.2254 10.6222 -23.4955 +21 1 0.00401405 1.51379 8.26626 1.73444 -9.97848 2.73777 +22 1 0.631563 2.29056 0.214422 2.30445 -4.73927 -16.4851 +23 1 0.869727 1.5347 0.919411 -20.3113 -10.6479 -1.82401 +24 1 -0.0840974 2.27001 1.15035 26.4165 13.702 -18.8298 +25 1 1.67911 1.38813 0.0883733 4.29152 4.16945 3.72554 +26 1 2.34463 2.397 8.3967 -0.661743 10.3894 16.138 +27 1 2.41792 1.69378 0.837891 -11.9994 8.17272 5.13712 +28 1 1.50784 2.3296 0.8821 15.8347 5.46342 -6.24169 +29 1 3.19181 1.77289 8.14083 -8.92279 -4.86777 22.8625 +30 1 4.12817 2.46218 8.33741 8.13153 -11.9637 0.536015 +31 1 4.26337 1.62555 0.809789 -13.061 44.2943 -8.13534 +32 1 3.42316 2.33556 0.802814 -4.29938 0.254861 -1.13643 +33 1 5.0669 1.62594 8.33933 -4.47953 5.08137 -8.2197 +34 1 5.91213 2.40952 0.124369 -13.9 -26.0969 3.99436 +35 1 6.23275 1.281 0.442008 -1.76602 1.09435 0.219677 +36 1 5.05785 2.29128 0.753897 1.63462 9.40663 2.64296 +37 1 6.76196 1.99075 8.08873 7.25593 -6.72787 12.2575 +38 1 7.89568 2.35083 0.217856 -14.3986 10.074 -11.1844 +39 1 7.7557 1.40697 0.992421 -28.0785 15.2332 -13.5573 +40 1 6.69672 2.20109 0.984157 0.465363 17.7913 -13.2761 +41 1 8.2159 3.42858 0.185567 12.3977 0.764361 -3.90376 +42 1 0.927092 4.2442 8.41258 -26.45 -26.3493 -4.33489 +43 1 0.729094 3.09987 0.813639 -4.58702 16.175 15.6607 +44 1 0.0788068 4.49033 1.02182 1.48174 1.40892 2.78463 +45 1 1.55842 3.1508 0.126599 -1.73889 6.5262 3.04002 +46 1 2.29185 4.09245 0.0493365 -0.242842 -5.39025 -0.756334 +47 1 2.41785 3.22623 0.89121 8.0106 -0.183268 -6.38994 +48 1 1.56843 4.03679 0.931375 1.76309 0.26565 -2.14494 +49 1 3.4359 3.23233 0.0225532 -4.36687 10.8322 6.25926 +50 1 4.25669 4.07361 0.0880133 2.8279 3.66932 -9.72921 +51 1 4.34048 3.08558 0.785495 -4.69141 6.70607 0.15029 +52 1 3.59299 3.90329 0.886528 -10.5717 12.5753 -2.99495 +53 1 5.13064 3.04982 8.22833 -0.225212 8.61676 17.0697 +54 1 5.81502 4.09178 8.38841 -21.2737 -2.05468 -24.8502 +55 1 5.97613 3.1773 0.894798 -5.61602 -19.9636 -19.3342 +56 1 5.09497 3.91821 0.747666 0.511602 -0.648627 8.1507 +57 1 6.51767 3.18724 8.3864 17.647 23.2966 -13.5196 +58 1 7.37164 4.03522 8.29689 -11.4262 -6.53116 -1.21962 +59 1 7.31211 3.24078 0.704535 -4.3132 -0.596821 4.84194 +60 1 6.56447 4.1734 0.602333 27.4745 -11.0091 36.7473 +61 1 8.15631 4.68203 0.075112 10.7012 -10.9934 -7.99724 +62 1 1.11663 5.88929 8.3609 -7.93077 -20.1145 9.26986 +63 1 0.996074 4.97243 1.21409 -6.72433 0.768332 -3.74364 +64 1 0.189403 5.66667 0.913187 -7.3538 -1.57168 -7.21317 +65 1 1.58163 4.94764 0.201022 19.1991 11.3216 -0.454803 +66 1 2.29237 5.73911 0.0748948 8.80602 19.0835 -4.47029 +67 1 2.49097 4.65203 0.981363 3.25616 8.72811 -9.97843 +68 1 1.87095 5.55306 0.995907 1.03553 19.7133 11.0025 +69 1 3.18407 5.012 0.131558 5.578 6.2636 9.58863 +70 1 4.09719 5.68255 0.132658 4.03261 5.63654 -2.85988 +71 1 4.12395 4.88832 0.852082 2.34539 -1.75572 -18.9743 +72 1 3.07234 5.70133 0.969327 -0.346407 5.49919 1.56796 +73 1 5.11274 5.00399 0.171908 -9.99815 3.39538 19.3609 +74 1 5.76656 5.80521 0.11529 9.4035 3.26414 21.2303 +75 1 6.01079 5.05469 0.873922 -27.3446 -31.3954 -10.6646 +76 1 4.89913 5.95208 0.960158 8.00863 4.38535 -8.86024 +77 1 6.75863 4.93475 8.31779 -18.6284 14.8779 13.2188 +78 1 7.8245 5.62001 8.34465 11.2383 14.3374 0.909184 +79 1 7.51856 5.31135 0.853265 4.91639 -9.6583 11.5193 +80 1 6.62461 5.81662 0.841147 8.94471 25.6435 -17.3923 +81 1 0.202013 6.46046 8.33455 0.0609498 5.25542 6.45446 +82 1 0.889578 7.53674 8.33221 1.62686 -1.40391 0.0530776 +83 1 0.953366 6.38848 0.908196 -1.46223 4.85455 -5.86941 +84 1 0.145952 7.39993 0.791819 5.48829 -5.75958 -9.51465 +85 1 1.67676 6.71324 8.36121 2.78795 2.25277 6.97945 +86 1 2.21164 7.54618 8.16806 16.5579 9.64776 9.50482 +87 1 2.40278 6.62803 0.856512 -0.674903 -8.3487 -4.56859 +88 1 1.53782 7.38975 0.90846 -3.10291 8.8481 -14.5459 +89 1 3.27325 6.398 0.0420856 1.14847 -3.14438 14.8868 +90 1 4.24204 7.28724 8.33928 2.62398 3.89094 44.6004 +91 1 4.04999 6.6211 0.862788 13.5756 -10.8829 -5.05866 +92 1 3.45704 7.41684 0.605416 -19.3758 10.5723 4.19592 +93 1 5.13383 6.59732 8.2884 -30.4967 14.0841 16.2852 +94 1 5.83566 7.60311 0.0824633 -14.5596 3.16754 7.91958 +95 1 5.71227 6.86684 0.81732 11.5827 -10.7391 -7.91805 +96 1 4.90381 7.61313 0.94797 9.27737 -4.87268 -6.49352 +97 1 6.72722 6.86314 0.253587 -5.2734 -0.113759 -0.620065 +98 1 7.41232 7.77996 0.331703 18.857 -4.07135 -25.363 +99 1 7.56998 6.39348 0.735875 7.28329 1.56003 -0.789213 +100 1 6.66601 7.84216 0.965777 -32.1881 -17.8038 12.8266 +101 1 0.166766 -0.00131261 1.94063 8.32296 1.94608 -3.28266 +102 1 0.934833 0.817938 1.81275 -21.8629 -14.287 17.2076 +103 1 1.00207 0.316008 2.82556 -21.807 -5.91521 -4.01431 +104 1 8.35945 0.74 2.72116 2.32177 4.37751 -0.902675 +105 1 1.48465 8.25372 1.60749 -1.18562 -7.12983 8.20441 +106 1 2.44318 0.774258 1.4766 5.48942 -2.99924 2.57908 +107 1 2.3069 8.18025 2.36522 1.41087 2.4731 2.95424 +108 1 1.85775 0.858752 2.6061 9.12182 6.5265 -4.79678 +109 1 3.23269 0.0488049 1.82801 0.784922 27.4455 -30.2613 +110 1 4.21175 0.99942 1.57195 -9.49462 -27.3711 22.4225 +111 1 4.21293 0.25409 2.38861 -7.75181 -9.25535 -4.23311 +112 1 3.32934 0.964581 2.65137 -6.01516 -9.0041 -1.19732 +113 1 4.9787 0.193499 1.50831 -4.98755 -8.3429 -3.28083 +114 1 6.09517 0.531101 1.76326 -28.5995 19.6806 -10.71 +115 1 5.85753 8.23852 2.51303 -1.20503 -8.99564 8.87124 +116 1 5.17785 0.685106 2.40543 -1.30449 11.3507 4.36005 +117 1 6.91213 8.37413 1.83271 8.62238 -24.2277 10.2354 +118 1 7.62368 0.758482 1.85178 16.0234 8.8439 -5.1341 +119 1 7.66132 8.34118 2.51601 5.03438 -8.87196 18.1761 +120 1 6.82917 0.875718 2.51872 -7.12717 1.70889 8.15245 +121 1 0.0949053 1.53257 1.83348 -15.8355 -28.5862 13.9628 +122 1 0.822415 2.21502 1.73119 16.0449 19.2167 -17.682 +123 1 0.864878 1.50475 2.57372 12.4143 -0.0682656 8.67505 +124 1 0.199844 2.34986 2.54349 -13.4424 7.82132 10.7389 +125 1 1.68463 1.52556 1.71378 7.71699 13.5023 1.83995 +126 1 2.69369 2.59616 1.91546 -20.6965 -6.26723 -3.29779 +127 1 2.60471 1.76603 2.62425 -5.19989 2.78858 2.334 +128 1 1.44056 2.43723 2.51936 11.6798 4.82752 9.65183 +129 1 3.43446 1.65477 1.84942 -9.01773 7.52097 -5.37653 +130 1 4.19061 2.39179 1.65045 11.7616 -7.21515 -2.54075 +131 1 4.26672 1.39737 2.67586 10.1937 6.39563 -7.12371 +132 1 3.53921 2.577 2.549 6.10272 -3.10086 8.1996 +133 1 5.17395 1.33784 1.40963 0.810412 -15.8822 3.29742 +134 1 5.74074 2.13809 1.54869 21.9361 25.9957 -3.59082 +135 1 5.9363 1.515 2.34901 -9.46258 -12.7333 10.9894 +136 1 4.95982 2.19781 2.39856 0.709797 0.431383 -4.3853 +137 1 6.78917 1.32128 1.47071 -5.63197 2.68115 20.8841 +138 1 7.62581 2.16504 1.87345 17.6788 -6.34038 -2.38007 +139 1 7.68847 1.62015 2.88771 -1.999 -29.1097 -18.0204 +140 1 6.72066 2.18015 2.22288 -25.5596 -3.13399 14.9826 +141 1 8.10556 3.24278 1.47587 8.10057 -1.81275 -31.7951 +142 1 0.698788 3.89936 1.58833 21.0059 -8.7854 2.84332 +143 1 0.726156 3.39424 2.59236 2.18368 -0.846434 0.375997 +144 1 8.21488 4.03893 2.09204 -9.31366 21.6556 21.1016 +145 1 1.61294 3.13444 1.56982 -6.75222 2.4564 11.7453 +146 1 2.47309 3.97186 1.76449 2.21347 -7.98753 7.5428 +147 1 2.67292 3.22702 2.95068 5.54423 5.59107 -13.8219 +148 1 1.72826 4.2557 2.53344 -3.42962 -20.862 21.8798 +149 1 3.48214 3.13902 1.56572 3.70104 11.9942 4.11222 +150 1 4.3885 3.8788 1.62665 2.95307 16.2819 -22.5535 +151 1 4.3065 3.38859 2.48531 -9.81397 -19.0665 24.4754 +152 1 3.47101 4.13314 2.35987 0.052847 -5.96917 4.43729 +153 1 5.11162 3.02695 1.57487 -2.09605 4.71156 2.60925 +154 1 6.05823 3.77666 1.6683 -0.0795953 27.02 22.5131 +155 1 5.89604 2.8633 2.33341 1.61726 0.0933652 1.12851 +156 1 5.29152 3.73349 2.43504 2.35223 15.5067 -10.4051 +157 1 6.82698 3.04592 1.66447 4.37333 2.796 -3.08497 +158 1 7.47158 4.33914 1.21316 -2.11938 -7.51647 -10.9268 +159 1 7.68828 3.1018 2.37066 -8.14673 6.79824 16.7729 +160 1 7.09384 4.0081 2.08909 -5.93874 -19.0069 4.73504 +161 1 8.1255 5.22391 1.77055 19.2122 -25.3413 6.96334 +162 1 0.62612 5.90176 1.99772 9.96713 -14.5554 -17.3464 +163 1 0.76801 4.79289 2.36504 -2.78355 1.48316 -1.85895 +164 1 8.18318 5.95034 2.62286 5.26633 -16.349 1.23379 +165 1 1.81648 4.94963 1.84319 1.29255 4.07737 -28.8924 +166 1 2.40619 6.07189 1.89723 9.11627 0.0929027 -31.5253 +167 1 2.58707 5.01704 2.50938 -14.4694 3.44726 -14.5204 +168 1 1.72272 5.71364 2.51972 -25.0056 3.38939 29.4203 +169 1 3.42498 4.85355 1.57173 -14.1697 1.2804 16.3608 +170 1 4.15303 5.79502 1.71807 -6.58651 -0.238746 -3.12281 +171 1 4.46167 4.86212 2.18786 -1.52672 -11.6836 -0.120829 +172 1 3.29589 5.94757 2.4039 5.86702 -13.0661 19.8541 +173 1 5.03295 4.96131 1.30642 14.6935 -5.33684 5.62219 +174 1 5.82775 5.80433 1.62537 -3.48018 5.04048 -3.36734 +175 1 5.79583 4.80394 2.11298 -5.34853 -5.63002 0.159279 +176 1 5.01708 6.04912 2.32216 17.4276 -29.4439 17.4564 +177 1 6.71539 5.10912 1.63093 10.3915 -7.52696 11.1074 +178 1 7.41693 5.91425 1.78268 -24.8131 17.7871 4.30264 +179 1 7.12646 4.86445 2.63426 13.6393 21.9613 3.08537 +180 1 6.42336 6.18201 2.43584 15.1603 10.9548 -7.96948 +181 1 8.23881 6.55347 1.60468 9.12903 0.565206 1.23333 +182 1 0.678624 7.37322 1.88745 -5.46988 3.49615 -25.4292 +183 1 0.794621 6.6529 2.67297 0.0873755 -1.33888 6.26964 +184 1 8.30959 7.39568 2.5723 10.9372 15.1486 20.2523 +185 1 1.53592 6.72715 1.69313 10.3025 -8.32698 21.6565 +186 1 2.52873 7.48993 1.45805 2.51224 9.72508 0.958573 +187 1 2.57516 6.97533 2.39376 0.331622 5.62636 7.11361 +188 1 1.48127 7.49186 2.513 25.359 1.87736 0.862705 +189 1 3.42472 6.67917 1.69715 -9.14691 10.5288 -4.39359 +190 1 4.07864 7.56162 1.54537 -20.7523 -1.21573 5.0956 +191 1 4.22077 6.65705 2.50099 -12.9989 13.269 2.80638 +192 1 3.32476 7.76609 2.51834 12.0821 -31.6775 22.1813 +193 1 5.18316 6.78911 1.6853 -16.2098 8.5059 -12.8052 +194 1 5.76367 7.66024 1.61411 8.21393 8.40414 -2.16429 +195 1 5.72928 6.97443 2.55641 -4.2085 8.68736 -3.41382 +196 1 4.81509 7.65411 2.27112 9.64741 4.31731 11.3389 +197 1 6.71673 6.6577 1.40921 -4.23135 13.1654 3.72162 +198 1 7.9523 7.57862 1.62003 -19.0505 2.7611 2.11499 +199 1 7.55182 6.74669 2.5625 -26.4699 -4.16644 -1.81267 +200 1 6.71006 7.32273 2.23599 -2.19037 10.3011 3.68982 +201 1 8.3209 8.25724 3.44082 -11.2006 13.9316 -31.0885 +202 1 1.1383 0.707726 3.88488 2.87074 16.2111 -29.5751 +203 1 0.710637 8.17953 4.00977 26.7141 2.01724 45.2521 +204 1 0.017483 0.84611 4.17688 -4.01486 -16.4278 3.15279 +205 1 1.83485 0.022043 3.36625 6.99225 9.16158 -10.2142 +206 1 2.5734 1.02544 3.4638 -2.67645 -0.861554 5.53773 +207 1 2.46831 8.35234 4.18841 -8.88118 2.57467 1.82808 +208 1 1.9704 0.882634 4.50547 -3.01692 -0.258051 -7.68015 +209 1 3.15194 0.11929 3.26603 1.99843 -0.203753 6.521 +210 1 4.16362 0.594977 3.39201 1.91533 3.30238 12.0146 +211 1 4.48096 8.3197 4.27248 -34.7907 27.9025 -6.28307 +212 1 3.49096 0.991035 4.39487 -18.0924 -11.2469 -3.89782 +213 1 5.15221 8.33246 3.40287 -4.49662 4.44033 -5.3065 +214 1 5.83668 0.780008 3.22544 8.18869 5.41063 4.37051 +215 1 5.71056 8.31473 4.3397 -0.683085 13.1798 -1.88784 +216 1 5.01734 0.796017 4.33297 -1.83196 10.7479 -11.7081 +217 1 6.55531 0.0226915 3.33292 8.64001 -7.40459 4.85944 +218 1 7.40254 0.734891 3.44283 9.92215 2.2266 -9.49047 +219 1 7.60175 8.41313 4.17692 -11.7492 9.12522 14.6015 +220 1 6.69717 0.884026 4.20434 -2.52907 -5.48675 3.38708 +221 1 0.266587 1.50956 3.42506 -7.49445 4.66836 1.70669 +222 1 0.834612 2.3929 3.4535 3.19311 14.9998 -2.79098 +223 1 0.966342 1.70753 4.27772 -2.38166 -3.63555 7.29451 +224 1 8.31528 2.54359 4.03878 16.7451 -1.36482 20.306 +225 1 1.65675 1.69619 3.39484 3.12529 -6.34044 -1.62009 +226 1 2.21998 2.62053 3.66497 -8.94713 -4.89956 5.05059 +227 1 2.70158 1.84855 4.22365 -4.21065 -7.00328 -1.279 +228 1 1.73069 2.39291 4.69998 -11.0397 -15.2385 -11.7518 +229 1 3.63597 1.81901 3.49635 -5.37102 -6.0004 0.428615 +230 1 4.5181 2.45307 3.50704 1.92291 5.38714 1.37796 +231 1 4.28022 1.61295 4.532 11.684 13.523 -0.759472 +232 1 3.49161 2.67545 4.21356 3.70186 4.50981 -2.53687 +233 1 5.05676 1.45985 3.45113 -18.7528 -7.6908 -2.02124 +234 1 5.59639 2.31007 3.23954 13.071 6.11501 -14.1907 +235 1 5.90515 1.58558 4.07201 2.34854 -1.44676 5.83562 +236 1 5.6448 2.61062 4.20904 5.92031 11.7583 11.4648 +237 1 6.60245 1.81532 3.22394 -0.344578 -17.0844 -10.2298 +238 1 7.7209 2.5366 3.23021 -13.9757 26.3091 7.5372 +239 1 7.59991 1.69339 4.17685 -3.31209 -2.6982 -2.62135 +240 1 6.7571 2.48096 3.97019 3.90879 12.298 15.8753 +241 1 8.32132 3.59836 3.32434 15.1974 -18.6025 -8.65377 +242 1 0.758776 4.28533 3.41911 8.12571 10.2206 -6.43372 +243 1 0.714283 3.43939 4.05789 10.8012 -17.4951 -4.32355 +244 1 8.37038 4.20103 4.16336 -19.0683 10.428 -9.16118 +245 1 1.7111 3.58985 3.37102 -4.50013 -9.39619 -9.22108 +246 1 2.7295 4.29586 3.34058 -27.7709 -28.5377 3.76594 +247 1 2.75779 3.49033 4.0215 3.07014 12.8072 -10.7423 +248 1 1.81597 4.04867 4.27403 8.34757 5.06165 3.43123 +249 1 3.63217 3.50284 3.43026 7.64322 -9.23013 -17.5251 +250 1 4.42979 4.3957 3.21235 -5.21891 -3.02116 0.669719 +251 1 4.46277 3.52681 4.13413 -5.3566 -4.51807 -16.5208 +252 1 3.52987 4.30614 4.06609 5.60483 14.7001 10.5939 +253 1 5.31574 3.44078 3.42467 1.48508 -5.70873 13.1076 +254 1 6.44336 4.14284 2.93215 -36.0911 1.99853 0.657603 +255 1 6.52296 3.60341 4.02819 -0.573509 -3.99567 -1.18998 +256 1 5.23388 4.48156 3.97453 6.55779 -4.33302 -0.590571 +257 1 6.75544 3.08581 2.98548 -20.753 -29.7898 -6.93237 +258 1 7.36113 3.83069 3.18965 17.3707 23.8596 11.1094 +259 1 7.68707 3.36428 4.36221 -8.90323 13.3285 -23.8114 +260 1 6.58157 4.70256 3.96292 -12.6487 -1.89838 -2.64764 +261 1 8.03895 4.72186 3.2072 7.03567 0.390199 -0.150374 +262 1 0.641986 5.57832 3.32415 -3.93783 9.97933 -29.9316 +263 1 0.748525 5.2954 4.26917 10.3198 11.1143 16.7142 +264 1 8.33552 6.07931 4.24855 1.05812 -13.5964 19.1647 +265 1 1.90145 4.96491 3.42288 -7.34814 1.12325 1.52157 +266 1 2.61408 5.80343 3.49254 4.58835 0.11833 -14.0758 +267 1 2.80014 5.15473 4.32615 -31.6367 11.9713 -55.3412 +268 1 1.9564 6.07585 4.27618 -9.91164 -20.8823 -47.0179 +269 1 3.37946 4.96765 3.07865 55.664 27.3093 14.9143 +270 1 4.23608 5.59453 2.88525 -18.9133 13.1689 8.33969 +271 1 4.44604 5.19737 4.14454 -7.57666 -13.265 -14.5347 +272 1 3.6416 5.84891 3.83409 2.65328 -4.22633 -4.19185 +273 1 5.15151 5.25659 3.1676 14.0924 -4.2121 3.02426 +274 1 5.82306 6.30397 3.36345 -4.54273 -6.47443 0.566248 +275 1 5.74908 5.5163 4.09569 25.3818 -3.33304 -26.8083 +276 1 4.83867 6.14359 3.79115 -4.65662 -0.583485 3.38738 +277 1 6.22614 5.32285 2.95137 -4.13422 -8.32687 15.6358 +278 1 7.32122 5.97196 3.33835 -0.00434101 -1.28454 -1.88403 +279 1 7.49659 5.17369 4.09183 8.55988 6.64783 3.63555 +280 1 6.75151 6.22479 4.25773 -16.211 -27.6787 -10.8075 +281 1 8.29215 6.64155 3.42114 5.59717 18.8581 -19.6047 +282 1 0.763473 7.56557 3.23404 -12.9198 -1.64007 -15.2341 +283 1 1.0031 6.68313 3.72439 -4.3972 -14.7662 15.3222 +284 1 8.23363 7.61771 4.35977 7.30279 -9.1197 2.90547 +285 1 1.95141 6.6466 3.21786 0.736159 0.439247 -2.07076 +286 1 2.6385 7.59536 3.37124 -4.27783 -4.21174 -0.733124 +287 1 3.13092 6.60025 4.41497 -19.4938 11.5887 -14.0245 +288 1 1.65818 7.53719 3.85187 -1.11019 -9.22082 13.1065 +289 1 3.27775 6.71474 3.27823 1.67015 1.07042 -3.65835 +290 1 4.1525 7.8844 3.3351 -7.70608 -2.7891 -4.06245 +291 1 3.98551 7.08252 4.24517 31.7093 2.51435 -5.83578 +292 1 3.40048 7.93533 4.31596 7.03572 3.0716 -3.37554 +293 1 4.94636 7.13355 3.35885 -28.0161 -11.5072 -5.66389 +294 1 5.84413 7.52046 3.45751 31.3517 19.8289 8.4284 +295 1 5.90459 6.85513 4.30093 -7.30307 7.57049 -1.80424 +296 1 5.01344 7.53745 4.4217 23.0153 -42.676 2.37557 +297 1 6.69892 6.88846 3.31402 6.29068 2.24472 -2.02408 +298 1 7.47533 7.68601 3.37673 -12.6934 -11.1052 -3.87233 +299 1 7.49921 6.86202 4.09322 12.1924 13.0141 4.3943 +300 1 6.67133 7.90635 4.38865 4.30856 -16.1011 -10.8357 +301 1 8.27296 0.0768914 5.12036 9.18301 -5.97843 0.553246 +302 1 0.892643 0.477473 4.83579 -15.0913 15.4009 20.7636 +303 1 0.772154 0.130661 5.99646 -1.43861 1.07866 -2.10387 +304 1 8.25515 0.935072 5.88754 -0.221723 -11.6722 -2.23691 +305 1 1.48963 8.06671 4.97048 16.9477 -1.8997 -3.71962 +306 1 2.57496 1.15847 5.28752 41.8653 -9.27812 4.61709 +307 1 2.98732 0.492219 6.35067 -4.54422 -4.60939 3.20868 +308 1 1.84275 0.524647 5.86961 -0.917224 0.841047 0.660751 +309 1 2.97903 0.200446 5.09803 7.97745 -0.922342 6.62523 +310 1 4.26317 0.578438 5.09777 -3.02519 11.3137 -4.68966 +311 1 4.18994 0.120263 6.02339 -4.93913 2.59189 23.6551 +312 1 3.50295 1.24619 5.79637 -4.00764 -7.55023 -4.67003 +313 1 5.12205 8.32679 5.40632 -5.25746 3.73248 -3.11501 +314 1 5.80677 0.859185 4.97868 15.281 -0.410171 8.11126 +315 1 6.05354 -0.0201647 5.97574 -7.51195 2.16668 5.49645 +316 1 5.29101 1.10125 5.89955 -0.302158 5.37706 -3.33259 +317 1 6.70998 0.244047 5.12411 -32.2188 -6.24411 4.81733 +318 1 7.52467 0.777062 4.96861 20.8677 24.3354 -3.82818 +319 1 7.29721 0.136872 5.99355 7.05953 -3.3845 7.97045 +320 1 6.54852 0.902142 6.09075 8.2259 10.3777 -12.9847 +321 1 8.3753 1.53724 4.98157 2.17311 8.15625 3.98817 +322 1 0.71432 2.51412 5.02068 -12.4966 -5.84806 3.10051 +323 1 0.855781 1.46858 5.93628 -12.4576 1.96544 0.341226 +324 1 8.11454 2.43493 5.75559 5.15623 -3.74122 1.07022 +325 1 1.70238 1.57115 5.35189 -38.5773 5.62525 -16.043 +326 1 2.46473 3.0428 4.8535 14.9609 2.21644 20.6584 +327 1 2.4829 2.11442 5.80082 20.2757 20.5564 -2.76238 +328 1 1.44662 2.4329 5.9576 0.543772 11.9562 -7.2005 +329 1 3.29597 2.05528 5.06702 2.85074 -1.27902 5.48838 +330 1 4.71392 2.67227 4.67311 -16.586 -2.70867 4.26173 +331 1 4.23981 1.93327 5.61065 17.5416 10.5589 -1.008 +332 1 3.69151 2.91031 5.72032 0.213325 2.13196 -1.69169 +333 1 5.26041 1.83667 5.02123 6.06702 -8.01086 0.159199 +334 1 6.29681 2.56022 5.09106 -5.44623 -0.683824 -15.8447 +335 1 5.97089 1.97948 5.90875 -1.39581 -8.65091 2.36208 +336 1 5.32016 2.78712 5.54952 10.0834 -7.57686 9.12967 +337 1 6.76335 1.53665 5.10381 -6.49311 3.28388 -1.62508 +338 1 7.39244 2.59867 4.94069 -6.65618 -18.4022 10.6664 +339 1 7.39034 1.59037 5.98163 7.99848 2.50507 -1.85372 +340 1 6.86792 2.60296 5.96513 8.836 -3.98323 2.68287 +341 1 0.137435 3.52069 4.93684 -4.66205 -5.7882 5.56144 +342 1 0.88525 4.34994 4.6075 2.988 -8.04302 19.8618 +343 1 0.671447 3.60221 5.79043 18.0943 -16.6493 20.2037 +344 1 8.34285 4.28087 5.95434 -19.6744 13.1619 0.969809 +345 1 1.33416 3.36295 4.99473 8.92189 5.92429 -2.5153 +346 1 2.50305 4.23267 5.05465 -27.5248 -20.908 0.492103 +347 1 2.36725 3.37012 5.84923 -17.1073 -9.96579 7.0021 +348 1 1.45211 4.29673 5.57493 7.54138 6.26423 2.50823 +349 1 3.47656 3.71778 4.99943 12.588 -10.9937 -32.8348 +350 1 4.53758 4.28685 4.7978 -5.49767 21.5926 5.59595 +351 1 4.66123 3.56451 5.54467 -12.8933 9.0868 3.25853 +352 1 3.16215 4.0016 5.8872 6.62501 12.8548 34.5501 +353 1 5.39268 3.59146 4.74919 -4.73905 -31.3011 -11.4087 +354 1 5.76113 4.47956 4.9574 18.7428 32.3973 -5.18443 +355 1 5.78815 3.80587 5.78982 -7.10304 0.117864 -2.90029 +356 1 5.02789 4.67913 5.68892 -14.5359 -3.59396 7.83253 +357 1 6.67716 3.56196 5.1655 1.61752 2.79183 -0.67852 +358 1 7.59448 4.24592 4.9803 -6.50366 -1.98045 6.72657 +359 1 7.59718 3.39514 5.76655 2.21878 7.1556 0.646608 +360 1 6.80163 4.43627 5.8851 -3.03056 -0.645399 -10.9559 +361 1 8.29576 5.01058 4.81068 0.626199 13.0736 14.2059 +362 1 1.05047 6.19551 5.02762 -0.156468 -7.32209 -14.0064 +363 1 0.578297 5.15849 5.72641 1.63655 2.26956 0.551951 +364 1 8.23943 6.07268 5.87533 8.87399 -0.526239 1.15285 +365 1 1.76527 5.31835 4.93011 -1.00084 -16.0238 11.4126 +366 1 2.88183 5.91468 5.07925 -22.1885 -17.105 2.25231 +367 1 2.65936 4.93415 6.03537 0.686882 11.6758 -2.90902 +368 1 2.03447 5.84592 5.92534 2.47635 -18.2138 -25.6325 +369 1 3.24392 4.86959 5.11086 62.6624 1.69747 54.073 +370 1 4.07402 5.91621 4.83335 -4.98562 8.578 9.29517 +371 1 3.92826 4.74513 6.11781 2.52773 6.36319 -4.5061 +372 1 3.44964 5.83627 5.89312 16.6713 -3.51566 20.823 +373 1 5.12814 5.53194 4.84592 -22.4422 -5.59515 37.2611 +374 1 5.90308 6.17208 5.1146 -12.9736 21.9443 6.65273 +375 1 5.95357 5.13374 5.81819 6.93561 8.02219 4.14964 +376 1 4.75268 5.76162 5.94655 1.5775 -0.40438 -5.87077 +377 1 6.51586 5.41565 4.90612 17.2134 -26.1979 -1.37429 +378 1 7.5279 5.93793 5.01527 -3.38884 15.9345 -12.1825 +379 1 7.6332 5.21687 5.72128 4.22628 -40.3472 -14.2075 +380 1 6.64022 6.14894 5.87989 13.3598 -6.13205 -0.934618 +381 1 8.34458 6.85129 5.15926 -14.2808 -7.95422 -4.25663 +382 1 0.833911 7.25078 4.85532 9.11386 4.17832 -8.89911 +383 1 1.06673 6.48225 6.01607 -14.203 -6.44505 8.15493 +384 1 -0.0379195 7.65497 5.88016 -1.75378 4.76646 1.63712 +385 1 2.12599 6.69323 4.98422 2.81787 34.3524 37.6883 +386 1 2.84758 7.50703 5.20442 -10.9987 17.1664 -16.5728 +387 1 2.77128 6.71691 5.85642 -9.44911 -10.1768 15.1935 +388 1 1.58013 7.32255 5.72901 16.1676 5.29147 -4.24753 +389 1 3.6768 6.91779 5.33962 13.4611 -20.8664 1.96557 +390 1 4.03881 7.88236 5.22897 2.57592 -0.812644 -11.9679 +391 1 4.4232 6.75921 6.19682 -8.5477 -5.71312 7.44018 +392 1 3.24799 7.72667 6.18249 0.719386 0.220585 -2.48264 +393 1 4.83295 6.89566 5.2507 4.97045 -2.42982 -4.77289 +394 1 5.87897 7.61282 5.14968 -20.2612 -0.49131 -22.7769 +395 1 5.75942 6.67532 6.09541 -7.34504 3.57141 -0.447292 +396 1 5.14318 7.54839 6.30602 2.0724 10.313 -0.219969 +397 1 6.74639 6.92855 5.00696 6.96871 -0.230218 1.29861 +398 1 7.3805 7.8124 5.23875 7.69485 -10.0795 -7.08489 +399 1 7.52596 6.88746 5.90198 -6.42674 1.56965 2.19774 +400 1 6.51888 7.44621 5.87193 29.4637 -7.18826 32.3539 +401 1 8.28476 0.000423359 6.72306 2.02553 19.5279 -19.3713 +402 1 1.01888 0.905848 6.82221 -28.6303 -12.8009 -18.3361 +403 1 1.24262 8.30657 7.44334 -32.4348 0.998186 -42.9826 +404 1 0.0211475 0.824091 7.47144 0.973424 -13.5355 3.24171 +405 1 1.94007 8.12144 6.72811 7.36532 0.254467 -18.2635 +406 1 3.02097 1.5587 6.75498 -16.6323 -17.6578 -2.8331 +407 1 2.39982 0.0370076 7.66598 -2.14889 1.34284 -3.48663 +408 1 1.9688 0.847456 7.09398 30.835 -18.1107 26.5169 +409 1 3.29942 8.17609 7.18194 3.78499 -8.25924 -8.09048 +410 1 3.92844 1.06207 6.75726 8.02723 -15.5891 -9.47025 +411 1 4.52946 0.167766 7.50023 3.36063 -0.839689 -4.02118 +412 1 3.29302 0.728616 7.56048 2.70434 15.6737 2.80228 +413 1 5.10415 0.332413 6.57695 -15.8309 -23.3459 -1.79261 +414 1 5.90656 0.845621 6.88018 -8.12621 13.928 11.6173 +415 1 5.71058 8.18101 7.57391 -10.3063 5.31817 -1.8554 +416 1 4.82988 1.18118 7.265 13.8593 7.32067 6.7543 +417 1 6.57919 8.43785 7.00021 11.8406 5.1504 -4.86933 +418 1 7.5282 0.806752 6.77786 -1.5451 6.42857 5.82496 +419 1 7.48349 8.33572 7.57521 5.34797 11.8467 16.9658 +420 1 6.70557 1.08836 7.47923 9.5713 -7.54062 13.1357 +421 1 0.0382442 1.56126 6.72749 -0.0966071 11.4911 -0.854867 +422 1 0.869187 2.34639 6.83989 -3.61656 -2.89703 1.60294 +423 1 0.999275 1.45672 7.67633 -8.0034 9.48038 5.5647 +424 1 0.139215 2.63275 7.64328 -15.7892 -20.5267 5.19008 +425 1 1.88893 1.53066 6.37684 -7.83006 6.68056 5.79142 +426 1 2.1935 2.73769 6.82665 18.0903 -33.7124 -24.8324 +427 1 2.37018 1.89864 7.50076 -8.8745 -17.5059 -13.2094 +428 1 1.48561 2.41457 7.71452 -8.23366 6.90197 4.22635 +429 1 3.39063 2.48859 6.68098 16.1595 11.6225 -22.1191 +430 1 4.55604 3.04369 6.47522 -16.239 -17.1818 -0.0461326 +431 1 3.92972 1.83682 7.47298 10.0225 0.0134714 -13.9461 +432 1 3.03012 2.73851 7.57823 -7.17652 4.30522 18.5475 +433 1 5.02119 2.07008 6.4546 -13.5258 -22.6225 -4.75661 +434 1 5.65211 2.81921 6.68199 10.7014 16.4385 -2.46135 +435 1 5.81386 1.77715 7.51287 -3.39579 0.139075 -0.667502 +436 1 4.71678 2.54344 7.41951 15.4924 -28.3106 -11.236 +437 1 6.66707 1.83619 6.71865 -2.24275 1.62817 8.66814 +438 1 7.65934 2.42567 6.78337 1.29364 23.1589 -24.9484 +439 1 7.60492 1.76056 7.50233 6.44148 -25.2098 19.19 +440 1 6.42541 2.6971 7.41321 1.20391 11.9169 -7.49803 +441 1 0.132604 3.18129 6.70867 -2.29445 4.14817 -3.79866 +442 1 0.662351 4.17412 6.80772 -12.4952 0.818831 -9.43638 +443 1 0.788837 3.4069 7.65946 13.9586 12.3209 -0.784492 +444 1 8.14087 4.12742 7.481 16.3072 -9.43806 5.16356 +445 1 1.48457 3.42655 6.6105 -23.5819 5.37731 -5.67472 +446 1 2.19532 4.19793 6.62241 18.5812 -12.748 4.0704 +447 1 2.03418 3.35836 7.57671 1.74798 18.3537 22.2752 +448 1 1.46881 4.26381 7.4306 10.5669 6.85755 16.1187 +449 1 3.40116 3.57046 6.96596 -19.5489 -14.8384 -6.51121 +450 1 4.14086 4.23036 7.04697 14.6332 24.1596 -34.0677 +451 1 4.37587 3.46381 7.58097 -0.667569 -11.1793 25.3659 +452 1 3.3081 4.23862 7.84495 3.59222 -23.7983 19.5534 +453 1 5.02719 3.92296 6.55308 10.3874 19.2736 1.42121 +454 1 5.99108 4.37569 6.77029 -42.1869 -21.9594 -11.1356 +455 1 5.60639 3.61515 7.4373 -8.14506 -14.6497 -3.14446 +456 1 5.05417 4.46396 7.7264 -7.96475 -5.84314 -22.6526 +457 1 6.56389 3.51182 6.41915 7.41692 -2.85266 9.06964 +458 1 7.47152 4.32616 6.69237 -6.16955 -7.38805 -5.63513 +459 1 7.53898 3.20716 7.62579 -2.06037 -6.09637 -1.14724 +460 1 6.59589 3.90993 7.45755 23.4751 -0.996001 13.7582 +461 1 8.21483 5.0816 6.83956 12.3265 -1.95746 -0.89439 +462 1 0.465403 5.98278 6.74845 -2.0373 -17.3355 -17.4636 +463 1 0.511394 5.19401 7.82937 -10.2185 -4.74355 -3.50015 +464 1 8.12271 6.05839 7.46163 -7.84524 3.1436 -8.24587 +465 1 1.48514 4.9291 6.5693 -9.22109 4.87392 -22.494 +466 1 2.40623 5.73649 6.97099 14.0591 -30.3418 -0.240996 +467 1 2.41461 4.96776 7.80425 -3.8539 -8.74065 -18.3704 +468 1 1.44923 5.49011 7.41 13.6015 -14.5185 13.7078 +469 1 3.24542 4.75566 7.0008 -15.7357 21.5396 -25.2781 +470 1 4.03587 5.88736 6.84618 18.4928 -13.3364 -12.8531 +471 1 4.10808 5.01612 7.64484 -5.1777 21.728 20.8534 +472 1 3.29694 5.8019 7.54893 0.566822 -11.9233 11.3035 +473 1 4.81889 5.07278 6.77721 5.06549 -4.43332 1.49875 +474 1 5.96641 5.77692 6.72214 -33.9279 46.677 -28.2473 +475 1 5.88193 5.34623 7.60234 -1.49551 -23.3855 17.2998 +476 1 4.83941 5.81133 7.62234 25.0546 -26.9624 -0.550707 +477 1 6.63577 5.08354 6.75153 63.1873 3.33413 5.12133 +478 1 7.44477 5.7383 6.53202 -8.94815 26.2377 30.0386 +479 1 7.45353 4.90407 7.60234 6.61529 10.6464 -15.3985 +480 1 7.05207 6.05238 7.85033 -15.5225 4.97074 -5.49642 +481 1 8.33549 6.95757 6.75022 0.367032 -2.97861 0.255273 +482 1 0.891414 7.50932 6.49478 -4.83629 2.79466 11.3618 +483 1 1.06555 6.40917 7.42656 -9.40876 15.4887 12.6203 +484 1 0.19507 7.80618 7.47535 7.27195 -18.2248 4.26121 +485 1 1.90915 6.5235 6.63557 -10.6214 46.709 18.7487 +486 1 2.60482 7.35009 7.06318 -2.87326 8.86923 -10.12 +487 1 2.54785 6.52686 7.66612 -14.5904 -1.60347 8.59865 +488 1 1.54201 7.28494 7.4147 7.26892 14.9372 -8.95427 +489 1 3.42163 6.7113 6.72693 -9.74068 0.0780566 2.81617 +490 1 4.07503 7.52705 6.85904 11.3718 5.59625 6.13428 +491 1 4.17032 6.5317 7.69612 -24.7224 6.99609 -12.8841 +492 1 3.30541 7.28919 7.8835 -6.45113 3.62128 -9.60987 +493 1 5.18135 6.6767 7.03146 3.30189 -12.2169 -7.11599 +494 1 6.1441 7.48882 6.87735 -8.40006 -9.95553 -2.76953 +495 1 5.99111 6.52776 7.79328 26.4283 6.66779 -19.7705 +496 1 4.88188 7.45813 7.61707 18.1033 18.9899 -14.9739 +497 1 6.70265 6.55612 6.94114 4.37785 1.73726 -4.76735 +498 1 7.52255 7.69097 6.78657 -11.7433 -15.8982 -13.9562 +499 1 7.60662 7.23551 7.85952 12.3776 -11.2962 -9.39843 +500 1 6.63368 7.62048 7.85195 7.88485 3.15928 -11.7162 +ITEM: TIMESTEP +300 +ITEM: NUMBER OF ATOMS +500 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +ITEM: ATOMS id type x y z f_2[1] f_2[2] f_2[3] +1 1 0.233349 8.13006 8.37458 -13.2268 13.2109 8.94155 +2 1 0.896766 0.85308 8.30255 3.22629 3.6978 6.45643 +3 1 0.859864 0.0707018 0.945242 -23.4126 -16.0712 -18.9613 +4 1 0.0588758 0.842768 1.07285 9.62638 -2.91549 -12.4893 +5 1 1.77938 8.21846 0.149185 -27.8434 -16.3109 -1.32989 +6 1 2.24018 0.700289 8.36085 16.269 9.92358 -3.41709 +7 1 2.6315 8.21417 0.711168 13.3859 0.245092 -3.82819 +8 1 1.39092 0.935915 0.985394 12.7346 13.01 -5.10945 +9 1 3.3176 8.39636 8.17869 -11.566 -16.9274 13.6338 +10 1 3.85219 0.815062 0.0370236 10.4004 28.9589 -3.67884 +11 1 4.161 0.0319779 0.627546 1.75904 -7.59281 -2.75644 +12 1 3.11636 0.817642 0.847547 4.80203 -27.6102 -6.44654 +13 1 5.13793 8.3571 8.28888 -5.17208 4.97346 2.0085 +14 1 5.70385 0.905818 8.12031 -17.8373 19.4407 -6.83741 +15 1 5.79877 0.0963845 0.817928 -4.38032 -1.5507 0.666839 +16 1 4.98412 1.21117 0.664665 -21.555 -8.66432 0.346644 +17 1 6.45061 0.296088 8.38812 3.42924 -28.9348 -2.0588 +18 1 7.77702 0.350545 0.295684 -0.731277 11.544 -2.82186 +19 1 7.70462 8.17101 1.16161 -8.03851 17.5755 -13.9844 +20 1 6.86494 0.586624 0.875444 5.58847 2.16197 13.2587 +21 1 0.100678 1.61145 0.0186749 -1.1873 -11.6656 4.66894 +22 1 0.998429 2.3998 8.22988 -7.28085 -4.5005 5.89326 +23 1 0.828996 1.87962 0.867267 -19.2592 -9.93125 -3.90703 +24 1 8.27374 2.4894 0.580898 8.78255 -11.7455 7.53659 +25 1 1.74048 1.62493 8.26739 -9.18296 -12.9889 2.92816 +26 1 2.39558 2.37629 0.0600193 9.87685 24.4855 1.90731 +27 1 2.45445 1.58898 0.877492 -32.2642 -6.64837 2.63885 +28 1 1.65243 2.45558 0.846906 19.966 -6.37675 -0.113589 +29 1 3.02408 1.54485 8.35689 5.59986 -7.64836 -2.85923 +30 1 3.92 2.20197 8.38732 -20.8443 12.2841 2.52306 +31 1 3.77985 1.57027 0.846646 20.9907 13.6119 -1.22324 +32 1 3.10388 2.34584 0.944358 6.32701 23.9593 -3.77688 +33 1 4.85706 1.878 8.25981 8.11354 -3.87323 -9.47245 +34 1 5.78268 2.09333 0.29673 -1.36849 16.4599 4.03726 +35 1 5.97863 1.20376 0.790291 32.0463 2.36619 -11.4383 +36 1 4.88385 2.45634 0.850397 9.78281 -16.7958 -1.62774 +37 1 6.62285 1.61835 8.29579 8.05661 -4.4773 5.02204 +38 1 7.55399 2.56197 8.18132 12.8994 -8.38166 15.4695 +39 1 7.59924 1.47112 0.768275 -0.340381 -2.67871 -5.54587 +40 1 6.74877 2.64386 0.753723 -17.0902 -18.9793 -10.4389 +41 1 8.35722 3.30339 8.29621 3.88209 -7.05803 1.13469 +42 1 0.765977 3.99405 0.477073 10.4517 2.49603 -17.2656 +43 1 0.831221 3.06707 0.900453 -8.35587 -6.78904 7.02328 +44 1 0.140436 4.39767 1.19127 -1.57081 11.5239 1.23833 +45 1 1.55351 3.27393 8.36662 -0.118073 6.26889 7.92677 +46 1 2.48303 4.16731 0.14908 -13.7582 -4.26857 1.92322 +47 1 2.37333 3.17517 1.02067 -14.4692 6.50264 -31.5071 +48 1 1.65701 4.17058 1.15287 -1.5797 -1.97941 -12.8817 +49 1 3.21438 3.21157 0.146996 -20.1594 -11.7694 11.9952 +50 1 4.28321 4.06082 0.235561 -7.01013 0.464645 -7.4456 +51 1 4.00184 2.96868 0.822048 -4.54826 25.7516 -18.5713 +52 1 3.26412 4.08833 0.821613 11.1851 4.36305 6.27367 +53 1 4.93889 3.19103 0.0459746 -2.17639 -1.1271 -7.48927 +54 1 5.93535 4.0528 8.21654 -1.56333 -1.65165 1.96928 +55 1 5.75576 3.15988 0.707778 17.6817 -13.2713 5.13403 +56 1 5.2315 4.02943 0.763223 -0.452475 -6.04463 7.12931 +57 1 6.80967 3.18308 7.98158 -23.2698 3.29018 18.9116 +58 1 7.84937 4.15894 0.139115 -10.2897 11.6744 2.993 +59 1 7.56351 3.24008 0.752033 -0.468845 18.0521 -12.3044 +60 1 6.70326 3.88955 0.624889 -0.941138 0.59008 2.25635 +61 1 0.263315 4.89557 0.260533 -21.3177 5.01328 -15.5704 +62 1 0.767954 5.80979 8.30607 7.59978 -5.84563 1.67074 +63 1 1.01162 5.03409 0.908989 7.54529 2.69929 16.3999 +64 1 8.38725 5.83431 1.00337 3.61589 -4.15339 -6.36164 +65 1 1.65923 4.84747 0.0732901 -12.2718 -7.14452 -1.11973 +66 1 2.34253 5.60198 8.30655 7.91513 22.3685 24.006 +67 1 2.47075 4.92775 0.922768 -5.69599 3.89765 2.66746 +68 1 1.65076 5.8624 1.08155 8.28384 13.1663 -26.7168 +69 1 3.21032 4.96288 0.0718385 6.90275 12.0583 4.83562 +70 1 4.31683 5.81091 8.2445 -6.07106 16.001 24.4162 +71 1 4.0022 5.10933 1.08243 -0.987394 -5.51353 -4.14418 +72 1 3.08952 5.8543 1.08001 20.7019 -13.8856 -23.646 +73 1 5.04193 4.8848 0.236201 -6.75887 8.84809 -11.6728 +74 1 6.01036 5.86922 0.147762 0.616812 -0.708561 -9.8882 +75 1 6.00591 4.76669 0.704892 -5.00399 3.30231 -11.9912 +76 1 5.15986 5.7957 0.727818 -36.1273 9.99449 -4.0864 +77 1 6.87642 4.89744 0.140008 2.16293 1.86546 -13.7103 +78 1 7.84039 5.5603 8.24691 -4.77039 2.45387 6.97935 +79 1 7.61247 4.95216 0.884224 61.5464 5.54866 -31.4574 +80 1 7.13999 5.87097 0.66837 -10.4004 0.446979 -1.0889 +81 1 0.284976 6.68434 0.215945 -19.2498 8.05662 -14.0567 +82 1 0.982876 7.472 8.30358 11.1034 -5.67626 13.795 +83 1 0.874256 6.63686 1.03265 -11.7399 -6.70777 -2.09767 +84 1 0.12523 7.53526 1.06205 -15.5002 -8.52158 -32.9301 +85 1 1.53836 6.56542 0.124336 5.81155 -2.74575 2.70263 +86 1 2.45566 7.24014 0.163939 -13.7862 7.0524 3.90305 +87 1 2.38368 6.64181 1.16489 5.19309 13.0368 -14.4547 +88 1 1.55777 7.42064 0.955187 2.95317 9.919 -9.12596 +89 1 3.26105 6.57879 0.277391 6.19764 -3.88127 -4.29904 +90 1 4.21681 7.50418 8.36589 0.418779 7.33048 -0.673966 +91 1 4.2136 6.71573 0.805769 6.02261 -2.81289 0.798739 +92 1 3.49573 7.57967 0.77094 -13.8185 -15.1907 -22.6007 +93 1 4.97943 6.65519 6.77102e-05 6.49698 2.41559 -0.5205 +94 1 5.78763 7.50739 0.0292034 7.17211 6.93093 1.18788 +95 1 5.70061 6.80412 0.815144 6.83872 -8.02569 -5.22668 +96 1 4.96155 7.64188 0.754906 -1.40971 0.48378 3.60676 +97 1 6.62543 6.75834 0.212141 20.3815 -6.72799 19.0936 +98 1 7.5054 7.54064 0.228699 5.02405 -0.59125 8.31674 +99 1 7.62741 6.7648 0.966544 10.8528 -1.51524 -6.86782 +100 1 6.51764 7.61106 0.794066 -3.58188 15.2202 -2.22905 +101 1 0.0861403 8.39942 1.77523 16.561 5.47177 12.0456 +102 1 0.798241 0.867486 1.90283 5.83429 -6.22483 -1.18959 +103 1 1.01882 8.16093 2.58804 1.69129 37.21 2.68102 +104 1 8.26047 0.933232 2.39213 16.6191 -6.94084 19.3019 +105 1 1.5043 8.31602 1.70005 24.5225 8.22354 6.48742 +106 1 2.3278 0.505699 1.44491 -1.87805 7.24432 12.5632 +107 1 2.30107 0.0675885 2.61736 -2.34035 -25.4089 0.204635 +108 1 1.65389 0.877547 2.65941 -7.28266 6.33447 -16.1438 +109 1 3.50019 8.31721 1.47862 -16.7888 14.1081 10.898 +110 1 4.01956 0.825924 1.54962 -26.8746 12.2857 6.16059 +111 1 4.07538 0.019132 2.44171 -4.87493 0.404402 -2.17065 +112 1 2.869 0.885962 2.4149 5.17917 -2.47967 0.533766 +113 1 4.73464 0.155071 1.4932 30.6868 -26.2406 6.98684 +114 1 5.62968 0.817396 1.64834 -4.04481 -8.77462 16.8173 +115 1 5.66865 0.0141325 2.50366 17.0023 -1.89327 -13.9307 +116 1 4.86842 0.817468 2.42132 32.27 -13.4362 -6.77265 +117 1 6.59541 8.31415 1.73549 -0.21361 15.3936 4.52423 +118 1 7.59767 0.742823 1.6565 -21.3952 4.75735 -8.6823 +119 1 7.60945 8.3635 2.38741 -3.47518 -4.35582 8.08118 +120 1 6.64964 0.766964 2.59458 1.86331 7.94862 -15.7507 +121 1 0.0966564 1.72383 1.66126 -2.3646 2.96568 -2.77323 +122 1 0.838875 2.52792 1.96878 -8.15441 10.7797 -1.95863 +123 1 0.90776 1.65168 2.68747 -10.1162 -2.78056 -2.47535 +124 1 8.34426 2.2614 2.55151 21.19 -10.0612 15.2043 +125 1 1.46427 1.72978 1.76157 8.28796 -9.22695 -3.48387 +126 1 2.37501 2.29161 1.76614 -0.0664736 7.90276 1.49641 +127 1 2.67166 1.85508 2.81423 -4.33867 8.71682 -6.36279 +128 1 1.69129 2.40006 2.69001 -6.84808 74.503 -77.1336 +129 1 3.2606 1.69371 1.92128 -6.02725 -3.6159 -16.3817 +130 1 3.94104 2.38885 1.63591 5.99851 11.0997 18.049 +131 1 4.04449 1.32304 2.52718 -28.9333 17.8748 13.0885 +132 1 3.64404 2.34301 2.71879 -4.29604 2.09188 -4.97764 +133 1 4.64091 1.6418 1.58405 19.1918 -0.189122 5.88078 +134 1 5.88395 2.31133 1.52544 0.0797298 5.40617 -9.4435 +135 1 5.7987 1.64961 2.35436 -3.46325 -3.79932 12.9903 +136 1 4.78244 2.22308 2.51874 2.01011 -1.75623 -4.81914 +137 1 6.65439 1.55727 1.69251 0.0481382 -10.7878 -2.86985 +138 1 7.4609 2.22018 1.51079 9.36137 15.4008 -1.67913 +139 1 7.50576 1.63853 2.4128 -2.97032 -17.2864 -0.621812 +140 1 6.87214 2.43415 2.42038 -30.5876 3.19651 2.74052 +141 1 8.27498 3.12542 1.46263 16.9155 1.32854 13.6822 +142 1 0.778659 3.95642 1.86807 -7.25106 -12.2522 -5.40095 +143 1 0.798965 3.10856 2.99966 -8.51883 26.4353 -21.6316 +144 1 8.39629 3.85082 2.58225 -5.99614 1.48776 4.40527 +145 1 1.68381 3.21805 1.79101 -5.77633 -5.0861 7.47296 +146 1 2.56903 4.03114 1.71918 -6.92524 18.9919 2.42009 +147 1 2.68821 3.054 2.58052 -0.955464 -0.812242 -0.180548 +148 1 1.68992 4.20726 2.20027 5.368 3.11181 32.2719 +149 1 3.19042 3.29104 1.54336 50.4233 -29.9172 14.5641 +150 1 4.30208 4.0236 1.30142 -3.92395 -1.77865 11.4065 +151 1 4.28898 3.18994 2.59219 8.96711 6.3942 -10.7611 +152 1 3.60727 4.0096 2.21837 0.742083 4.13896 4.48687 +153 1 5.11886 3.09922 1.66619 -2.87182 6.36609 5.71268 +154 1 5.98984 4.3721 1.6574 7.23512 -22.1503 15.9695 +155 1 6.06757 3.38048 2.48886 -0.631751 -1.09061 1.54872 +156 1 5.04095 4.05582 2.29794 7.98224 -6.57422 -3.38111 +157 1 6.80585 3.23363 1.61955 1.81547 4.43083 5.90353 +158 1 7.6107 4.12271 1.4985 -13.6918 -18.0547 7.51636 +159 1 7.71076 3.00605 2.3508 1.14441 21.4666 -12.0177 +160 1 6.92831 4.10176 2.31565 -3.92153 2.58619 4.8482 +161 1 8.33973 5.1724 2.08404 -22.306 -14.8391 -35.8531 +162 1 0.860537 5.83051 1.79504 -25.5953 10.3696 1.23396 +163 1 0.802813 4.96181 2.52052 20.0549 -14.1798 16.2425 +164 1 8.20479 5.88748 2.7573 8.86056 43.8975 -14.7096 +165 1 1.62556 5.15881 1.79421 13.6671 -60.0224 -43.8322 +166 1 2.44832 5.82052 1.83706 -21.0979 -8.85922 15.9808 +167 1 2.35829 4.95884 2.60055 5.56499 -3.25718 -17.7316 +168 1 1.57047 5.68188 2.57793 3.26945 48.3874 60.3367 +169 1 3.12962 4.94115 1.79611 3.44797 3.66295 -7.67081 +170 1 4.533 5.88518 1.61818 -3.82507 3.84853 0.541056 +171 1 4.41047 4.91386 2.27111 -7.04817 9.97354 -0.554451 +172 1 3.1705 5.97206 2.56867 13.8835 0.36015 7.54685 +173 1 5.10201 4.84379 1.45925 -8.99072 13.7146 -7.42642 +174 1 6.04077 5.71462 1.17105 24.8221 7.94918 20.2395 +175 1 6.02655 5.34395 2.16117 8.67798 2.32994 -0.236737 +176 1 5.13754 6.13757 2.45889 -19.0768 2.88926 -22.199 +177 1 6.81157 4.98564 1.3948 -36.2833 4.79272 33.0954 +178 1 7.60086 5.99469 1.7372 -3.24829 -8.45789 -2.93345 +179 1 7.33283 5.34101 2.57932 2.07328 -12.097 -6.46632 +180 1 6.77196 6.24125 2.34214 -17.3674 -5.70799 13.1243 +181 1 0.0250537 6.6606 1.72753 8.49396 4.93702 8.33356 +182 1 0.795762 7.59079 1.77266 12.7999 -27.3678 15.1487 +183 1 0.926657 6.70523 2.69571 -0.793657 3.91691 -3.18748 +184 1 0.160908 7.59778 2.74546 -5.44053 4.97464 -19.9661 +185 1 1.54893 6.69469 1.77147 8.37496 4.15768 30.0144 +186 1 2.38553 7.66265 1.59156 1.85092 -2.31642 6.75994 +187 1 2.52893 6.74213 2.34554 9.20138 12.1517 -25.6716 +188 1 1.80175 7.4451 2.61158 -6.78811 17.5009 -13.1399 +189 1 3.38458 6.74038 1.57533 -10.1646 -3.59545 3.61897 +190 1 4.095 7.47851 1.58866 27.0187 15.4009 2.51878 +191 1 4.11379 6.83 2.37783 19.5598 -18.1657 -14.1463 +192 1 3.12959 7.71074 2.36405 10.6634 -2.49932 -15.2866 +193 1 5.08729 6.94297 1.62592 -21.1801 -24.4484 5.07107 +194 1 5.73581 7.71377 1.57745 5.16642 11.3097 -0.890489 +195 1 5.92001 7.08484 2.45291 -0.193261 -0.933403 -1.70059 +196 1 4.83819 7.59024 2.39768 8.18574 14.9342 11.0206 +197 1 6.61545 6.66525 1.38958 -18.6406 -25.8802 -11.2439 +198 1 7.15994 7.45994 1.57935 11.6501 4.19084 33.778 +199 1 7.56748 6.9114 2.40976 10.0926 4.81165 9.43494 +200 1 6.80428 7.72449 2.78938 -1.24224 -1.60677 -10.8659 +201 1 0.159784 0.136544 3.24366 -1.32953 4.05967 1.66335 +202 1 1.00698 0.811307 3.51207 1.50245 1.78035 6.01503 +203 1 1.34713 0.12551 4.66914 -24.521 -31.0514 3.16868 +204 1 0.0655245 0.668593 4.25847 -0.855275 2.59789 -3.35749 +205 1 1.74942 8.37675 3.57933 -10.207 -16.1779 -1.21978 +206 1 2.26863 0.82911 3.48792 22.6881 17.8048 9.09595 +207 1 2.33553 0.183914 4.4711 16.8323 -1.13179 -15.08 +208 1 1.7049 1.03332 4.4695 6.78822 33.3459 -7.07653 +209 1 3.29237 0.411287 3.32326 -2.12858 -4.79866 -0.866625 +210 1 4.21141 0.796867 3.72276 15.2258 15.2508 -15.0202 +211 1 4.33441 8.33993 4.30342 13.6521 7.25398 3.1725 +212 1 3.45786 0.725922 4.42039 -13.4693 -6.1715 4.46767 +213 1 4.89231 0.0473082 3.15782 -6.25621 1.30634 20.3282 +214 1 5.77362 0.736119 3.37748 -9.09312 1.23928 -13.4649 +215 1 5.99071 8.04065 4.47949 -15.8189 13.2428 -8.46949 +216 1 5.196 0.682234 4.2587 4.7081 -6.90451 -0.266688 +217 1 6.57106 0.145322 3.40637 19.3462 -23.2913 17.9258 +218 1 7.59401 0.663732 3.46257 -2.8602 2.11131 -2.24016 +219 1 7.44242 8.25412 4.2449 1.11307 19.9225 9.74876 +220 1 6.62382 0.709572 4.35284 3.66026 3.16927 -3.64727 +221 1 0.0779483 1.38159 3.37319 -4.4953 5.38733 3.01304 +222 1 0.974278 2.30233 3.53228 -23.5961 -13.9704 29.7447 +223 1 0.524182 1.77379 4.53785 8.44119 -12.0369 -19.76 +224 1 8.32657 2.54461 4.19453 11.685 -8.01921 4.29442 +225 1 1.79699 1.78778 3.36592 20.9053 -94.2146 75.3552 +226 1 2.26904 2.65097 3.69138 3.64635 0.74501 -3.21688 +227 1 2.67429 1.70202 4.43144 -1.62218 -6.52331 -3.16444 +228 1 1.67869 2.25152 4.52595 21.8057 -26.9163 -24.6655 +229 1 3.42529 1.64095 3.50559 7.24234 -14.969 7.63922 +230 1 4.36843 2.51227 3.48596 2.07064 -5.87084 11.4812 +231 1 4.83369 1.71242 4.31187 -12.4342 -5.24453 -2.55025 +232 1 3.42697 2.55135 4.03879 13.1661 -11.4647 -6.22039 +233 1 5.09889 1.5127 3.30322 -10.1348 7.40169 -7.59726 +234 1 6.05204 2.45182 3.35855 -5.34479 4.21286 -4.99107 +235 1 5.91247 1.54121 4.03978 -1.19872 3.24833 9.47786 +236 1 5.34566 2.59829 4.30389 3.31953 7.26855 -16.7286 +237 1 6.74657 1.65018 3.27179 -23.12 -29.0051 -3.67746 +238 1 7.53263 2.23686 3.30386 26.344 22.8452 7.39879 +239 1 7.49613 1.58204 4.21155 10.9589 -18.8504 -4.35663 +240 1 6.70452 2.2326 4.19472 -13.7578 19.073 -7.70781 +241 1 8.04948 3.18864 3.48276 7.81989 17.0755 -15.6642 +242 1 0.420364 4.02026 3.62891 2.0762 -18.0048 -13.8871 +243 1 1.02911 3.20723 4.10028 2.87528 5.61338 3.46722 +244 1 8.23518 4.59996 4.24867 -9.72892 -14.3069 11.6196 +245 1 1.79813 3.62221 3.14835 -2.38332 -26.1643 0.00682256 +246 1 2.74246 4.09054 3.06778 10.2172 -0.241531 -5.01738 +247 1 2.65108 3.56469 4.0066 1.29528 2.95166 -0.450344 +248 1 1.68753 4.16642 4.41008 0.531244 0.36282 -0.905409 +249 1 3.56157 3.26659 3.34031 -15.156 16.0178 -13.2173 +250 1 4.30786 4.20161 3.07587 -3.71718 9.6458 -20.0534 +251 1 4.29173 3.71129 3.93288 2.63232 -25.6185 20.4798 +252 1 3.34785 4.41255 3.95574 4.30294 0.337698 1.30747 +253 1 5.19196 3.15058 3.27975 2.68017 7.34728 -0.723223 +254 1 6.11836 4.37563 3.09786 3.48097 -0.455645 -7.15348 +255 1 6.16379 3.4966 3.8024 -0.493793 0.0328113 2.1336 +256 1 5.30251 4.52711 3.80393 -16.2632 -25.1941 -0.0075048 +257 1 7.08947 3.30091 3.10932 -23.6486 5.19633 4.56168 +258 1 7.44697 4.43668 3.27896 -0.511887 -2.93371 -0.292771 +259 1 7.26132 3.68038 4.11877 19.5278 5.77559 -31.2062 +260 1 6.65227 4.59556 4.02535 -2.98634 0.729124 1.77093 +261 1 8.32438 5.07972 3.31456 7.45197 -18.3523 8.49382 +262 1 0.7239 5.87238 3.35063 13.9037 -7.68163 -11.6827 +263 1 0.86133 4.86733 4.0112 5.23908 17.06 9.33784 +264 1 0.110376 5.99228 4.15088 -19.5006 -5.14624 15.1727 +265 1 1.63326 4.60922 3.31023 -1.76723 17.8491 2.08855 +266 1 2.40135 5.61695 3.38494 19.4662 4.44663 -11.3673 +267 1 2.36184 5.08435 4.31966 -1.81965 -14.9274 -8.60789 +268 1 1.71701 5.94552 4.03684 -24.0402 -0.0953197 5.79012 +269 1 3.43912 4.9954 2.79577 7.89838 -10.7079 17.2388 +270 1 4.22838 5.86109 3.02821 33.6181 3.37383 -45.0173 +271 1 4.24887 5.06359 3.71273 2.64953 -0.546445 2.15952 +272 1 3.55742 5.92395 3.71083 -38.5919 -3.44905 39.4056 +273 1 5.41837 5.23828 2.98577 -11.447 -4.74628 10.7983 +274 1 5.86494 6.22754 3.11739 14.9731 7.40151 22.8162 +275 1 5.75467 5.37436 4.08221 13.6205 23.921 6.83069 +276 1 4.77382 6.13694 3.95439 -2.74813 -13.8938 10.4295 +277 1 6.55906 5.4789 3.24844 0.234698 -8.05013 11.4476 +278 1 7.53331 6.151 3.48116 -10.0459 9.16913 -20.7264 +279 1 7.59712 5.40949 4.12314 -10.2706 -23.4933 17.211 +280 1 6.76315 6.15422 4.20451 -8.32818 -2.13306 4.306 +281 1 8.33074 6.79274 3.30017 10.9969 -9.86444 14.3566 +282 1 1.03943 7.60681 3.41422 12.8839 -22.0033 7.43641 +283 1 0.876997 6.68124 4.1033 12.4942 12.9257 -7.86127 +284 1 0.320289 7.62896 4.11358 -19.9566 8.93301 7.64028 +285 1 2.12233 6.73507 3.25947 -6.36672 -13.9408 34.1069 +286 1 2.9278 7.71082 3.35699 -9.10575 13.9767 3.53664 +287 1 2.86555 6.96099 4.04549 -8.29151 -16.9355 4.68952 +288 1 1.89553 7.49272 4.25249 -6.95602 2.25366 -4.36835 +289 1 3.55128 6.82828 3.17739 -22.1877 4.18931 17.356 +290 1 4.1661 7.71123 3.4095 -5.10369 -4.69259 -0.796458 +291 1 3.89274 6.87937 4.19693 15.4298 1.82254 7.44647 +292 1 3.39266 7.95134 4.30177 -1.7872 -21.2114 -27.9517 +293 1 4.99714 6.86548 3.27273 -3.15325 15.5146 -9.80269 +294 1 5.7604 7.67976 3.37293 2.05238 1.22428 3.6757 +295 1 5.73479 6.76996 4.15088 6.33474 -4.66485 -1.392 +296 1 5.07616 7.57695 4.40446 -13.6351 -7.42167 0.514113 +297 1 6.73778 6.81794 3.33301 -3.54485 0.402493 -5.08336 +298 1 7.71498 7.67053 3.44695 -0.752689 -3.6099 -11.6949 +299 1 7.71759 6.87965 4.22182 -5.11403 5.07303 3.22293 +300 1 6.7649 7.45476 4.17956 6.56157 -12.3801 -0.724651 +301 1 8.19197 0.136233 5.17288 2.67067 20.6746 -19.9914 +302 1 0.776102 0.931351 5.08619 -1.70464 -8.91233 1.85235 +303 1 0.888781 0.0179834 5.65999 -4.55543 21.0031 13.534 +304 1 8.38466 0.737331 6.00004 -6.63761 5.81892 -3.68334 +305 1 2.17326 8.16764 5.48567 -30.0571 8.40977 9.50779 +306 1 2.68565 0.975823 5.34104 11.1467 5.8174 -19.2362 +307 1 3.06444 0.336871 6.1128 1.74673 -5.08128 15.5867 +308 1 1.94778 0.751629 6.0231 -12.5402 -6.77103 11.9096 +309 1 3.09215 -0.0018856 5.12048 23.3711 9.80891 31.3016 +310 1 4.54285 0.96074 5.03055 -10.8439 -8.47943 8.00065 +311 1 4.19772 8.25187 6.2874 -2.87662 7.25597 -11.3947 +312 1 3.73883 1.45482 5.73884 -5.31372 -3.16529 -7.8226 +313 1 5.15615 8.35466 5.42348 2.42368 -1.79965 -6.24325 +314 1 5.91471 0.891384 5.15303 -5.07011 -3.09253 -0.460458 +315 1 6.03745 8.35632 6.14961 -1.39208 3.8678 -5.18235 +316 1 5.2121 0.86593 5.98804 -13.8254 0.446509 -12.536 +317 1 6.68868 8.34181 5.14194 3.9888 6.48649 16.9974 +318 1 7.34021 0.809849 5.26372 -2.78853 -11.1974 -10.3326 +319 1 7.36245 8.30575 6.05369 1.98185 25.0408 -10.0092 +320 1 6.64158 0.85851 5.99168 -3.68623 1.19752 6.36998 +321 1 8.13309 1.40671 5.10096 17.8835 4.45702 -4.02515 +322 1 0.892662 2.59499 5.00421 -20.8235 21.437 24.4928 +323 1 0.773043 1.57142 5.91415 4.22614 9.86073 2.56515 +324 1 8.33239 2.57823 5.60038 -0.623629 0.0892147 1.2306 +325 1 1.87225 1.66498 5.43985 -2.48264 -4.0236 -4.58226 +326 1 2.75473 2.72259 4.73435 -30.311 11.1987 -1.55273 +327 1 2.93165 2.12687 5.49641 -1.73472 -35.7803 16.6222 +328 1 1.7335 2.58373 5.90704 -3.71318 12.7214 1.30751 +329 1 3.77896 1.69526 4.65032 1.63977 11.6216 2.36832 +330 1 4.33882 2.78478 4.62298 7.45227 7.00188 -24.1667 +331 1 4.0935 2.44339 5.52545 -11.3615 -7.17888 20.8862 +332 1 3.18285 3.03749 5.86709 11.7107 14.2608 -10.1303 +333 1 5.16253 1.77254 5.33362 4.38648 8.73211 2.03951 +334 1 5.9743 2.78241 5.0854 16.8461 0.569184 7.37091 +335 1 6.05449 1.8557 6.00418 -1.07841 -2.85482 0.754485 +336 1 5.02736 2.93607 5.49369 -0.394928 -5.32288 -0.0457358 +337 1 6.65738 1.68333 5.09298 2.04945 -3.50949 1.46808 +338 1 7.506 2.4535 4.81544 -2.36267 6.50792 21.426 +339 1 7.5049 1.81157 5.81254 2.0705 -7.66144 9.63716 +340 1 6.81799 2.57614 5.74327 -5.22025 12.4071 0.584392 +341 1 8.08209 3.4329 4.82809 -0.388102 0.733533 -0.302449 +342 1 0.687603 4.05264 4.91973 13.3113 7.10483 -26.1293 +343 1 0.927182 3.40713 5.70883 1.42 -2.21252 8.41121 +344 1 8.39125 4.08596 5.64374 -17.7983 3.69834 21.9629 +345 1 1.85335 3.18328 4.91159 -22.5662 10.1648 8.61749 +346 1 2.62594 3.83741 5.0269 -11.5374 29.2389 12.1219 +347 1 2.23001 3.64598 5.99431 12.2251 -19.0314 6.6066 +348 1 1.61612 4.36322 5.62412 -4.72812 -41.6645 3.65456 +349 1 3.49026 3.4159 4.80384 34.5623 1.92174 -9.26957 +350 1 4.42781 4.48169 4.58587 2.89283 12.0072 14.2383 +351 1 4.32987 3.73273 5.40213 -1.15236 0.923586 4.29704 +352 1 3.35747 3.99106 6.24745 4.6285 19.5949 -5.94829 +353 1 5.1733 3.66262 4.57851 -0.760359 -3.40804 -5.73178 +354 1 5.75745 4.60154 4.93992 12.48 38.3619 -39.183 +355 1 5.60952 3.84508 5.51193 1.72033 -36.6996 37.1733 +356 1 4.90838 4.64872 5.58962 -7.33472 10.9707 -1.22542 +357 1 6.81366 3.55073 4.97382 -24.7572 -16.3635 34.7513 +358 1 7.36231 4.42367 5.08055 17.1166 2.62568 -2.95463 +359 1 7.4725 3.41969 5.92572 4.71216 -0.444272 -3.67252 +360 1 6.56495 4.37474 5.82163 -0.033274 -9.82017 -6.2351 +361 1 0.041011 5.18659 5.08838 -22.5443 6.51501 -27.8507 +362 1 1.02655 6.1046 4.9959 -2.55187 -8.42255 -9.06362 +363 1 0.725543 4.91454 5.73466 12.2313 -2.94426 20.5318 +364 1 0.0422288 5.86356 5.87032 0.0942915 12.4442 -1.56822 +365 1 1.61098 5.19782 5.1268 2.44581 33.2387 -21.9348 +366 1 2.65636 5.69092 5.09384 11.8609 0.215073 14.2086 +367 1 2.6104 4.85981 5.98721 5.66035 -5.70161 -4.77737 +368 1 1.90538 6.1737 5.70769 -41.2624 -24.39 16.3086 +369 1 3.46858 4.77582 5.16944 -0.707582 -1.43422 0.766057 +370 1 3.76426 5.90532 4.89181 3.4437 -1.11423 -2.15979 +371 1 4.07073 4.92867 6.32743 11.4607 -11.4553 -4.32634 +372 1 3.67793 5.86643 6.05942 -4.35866 5.03724 -1.47182 +373 1 4.98792 5.51389 4.93524 -8.4187 -10.8933 -4.11136 +374 1 5.89023 6.01641 5.05179 11.0493 7.97987 -0.316877 +375 1 5.84913 5.21289 5.8287 7.09495 5.60009 -11.1489 +376 1 4.95887 5.92462 6.03819 -1.41241 -1.47294 -8.90972 +377 1 6.72618 5.24569 4.87739 -4.6501 10.2679 6.06598 +378 1 7.69701 6.07801 4.9728 1.45309 -5.4044 1.15049 +379 1 7.57443 5.25318 5.8022 -4.19719 -6.86637 2.5693 +380 1 6.75672 5.96198 5.84181 4.25859 -4.73277 0.116077 +381 1 0.149236 6.9327 4.88187 0.301354 -7.8021 16.5737 +382 1 1.06612 7.54377 5.19235 6.17987 -18.0682 -12.1896 +383 1 0.908663 6.67909 5.83913 1.89859 7.5565 8.00921 +384 1 8.3967 7.73373 5.73713 17.5958 -22.201 25.7152 +385 1 2.09262 6.53099 4.7967 1.84262 19.7267 -15.5304 +386 1 2.6809 7.4184 4.97144 1.84587 -3.02643 6.66108 +387 1 2.76451 6.5131 6.02372 26.4927 9.3308 7.09081 +388 1 1.89235 7.21971 6.07993 -5.61302 23.442 -46.1583 +389 1 3.56452 6.91614 5.29782 1.29026 -2.451 2.37678 +390 1 4.22056 7.80764 5.23329 -2.48711 -3.82055 1.83806 +391 1 4.29263 6.77471 6.12925 7.35038 5.5119 -5.7056 +392 1 2.85273 7.60961 6.07343 16.4578 1.27697 -7.39815 +393 1 4.81773 6.56695 4.97715 -1.40117 8.33727 3.10183 +394 1 5.78811 7.39325 5.43254 7.66799 3.74746 -17.7564 +395 1 5.91597 6.55237 6.07292 -10.3134 0.875812 3.19143 +396 1 5.1536 7.54901 6.2302 -8.62748 1.72241 13.4381 +397 1 6.84976 6.76387 5.09828 -3.19969 2.83039 -4.79256 +398 1 7.54117 7.72913 5.1763 -12.4453 -25.3207 -11.2598 +399 1 7.70324 6.72981 5.83369 -19.5261 3.79708 -10.3274 +400 1 6.77336 7.41197 5.93794 -9.93531 -0.946567 -12.2979 +401 1 8.22949 8.35705 6.76928 1.64244 -1.45449 1.77988 +402 1 0.72004 0.832942 6.72959 22.4465 -5.361 -6.29847 +403 1 0.883022 0.0931191 7.57241 -5.23405 -15.4407 -5.32038 +404 1 0.0468789 0.82113 7.48906 -16.6351 2.71194 14.972 +405 1 2.03902 8.21121 6.63645 7.11775 -8.1199 -7.72414 +406 1 2.8098 1.35985 6.35749 11.4457 2.58538 -2.95276 +407 1 2.39096 8.06897 7.6788 1.19633 7.68608 5.18448 +408 1 1.75996 0.580686 7.28683 6.89284 15.6237 4.36189 +409 1 3.24708 7.93738 6.98795 5.84043 19.9452 -24.3758 +410 1 4.23919 0.919929 6.46503 -1.07654 -9.91612 -5.08402 +411 1 3.90772 0.424381 7.41946 37.0812 -23.6824 -3.45202 +412 1 2.91871 0.505987 7.33506 -26.0302 7.74114 -11.0468 +413 1 4.92803 0.11282 7.09764 -8.28234 1.33652 -4.84063 +414 1 5.89475 1.0043 6.70526 7.29393 0.830325 27.9656 +415 1 5.8956 8.35718 7.44426 -3.02776 0.024361 13.8614 +416 1 4.71342 1.28665 7.29701 10.263 5.35948 11.5905 +417 1 6.8248 0.0574117 7.01961 11.7828 1.29904 -9.90689 +418 1 7.52034 1.04303 6.65362 -4.17639 -6.17679 3.43381 +419 1 7.73603 8.17986 7.79994 1.7859 4.36245 -17.9939 +420 1 7.13318 0.752429 7.78463 13.3591 3.5282 -5.71599 +421 1 8.39243 1.66394 6.67161 -0.134672 7.39125 4.10576 +422 1 0.854509 2.49412 6.65204 0.887161 -2.38052 0.586225 +423 1 1.18138 1.63924 7.31791 -41.6971 -18.352 25.0151 +424 1 0.0943458 2.334 7.66786 0.324396 10.57 -15.5201 +425 1 1.87867 1.74452 6.645 -1.95754 3.46436 -44.2754 +426 1 2.63684 2.47303 6.52845 -8.45632 -20.7999 4.28943 +427 1 2.51699 1.47554 7.37579 1.92109 3.65888 22.6814 +428 1 1.82876 2.39767 7.50566 14.4123 21.9409 0.136363 +429 1 3.78398 2.21463 6.57246 -2.68631 2.13236 -0.792617 +430 1 4.46308 3.07592 6.43555 -3.89191 7.33892 -9.13636 +431 1 3.59875 1.35397 7.20413 -9.98874 22.9069 2.08665 +432 1 3.19396 2.3577 7.56493 -2.6719 3.09783 -0.16421 +433 1 5.06299 2.1644 6.37533 -2.58633 -2.00836 2.79809 +434 1 5.67119 3.15784 6.34996 -0.566548 -6.83481 -5.10746 +435 1 5.66575 1.97666 7.57441 -14.7077 -20.3342 4.08546 +436 1 4.67442 2.64884 7.36908 -6.67424 -36.8328 0.644107 +437 1 6.68154 1.59605 7.24042 -18.9747 -1.14386 -19.0037 +438 1 7.52504 2.47849 6.70825 -1.30537 -8.16455 -5.2397 +439 1 7.60687 1.7083 7.61907 22.0172 -9.53549 -2.5479 +440 1 6.29708 2.66318 7.23348 12.1765 11.0009 -15.9537 +441 1 0.116615 3.32613 6.70965 -8.35482 -2.36763 -31.1169 +442 1 0.754871 4.30259 6.64315 -6.49201 3.33528 -9.76479 +443 1 0.673999 3.30917 7.54182 21.55 -11.008 11.6004 +444 1 8.2904 4.07274 7.4316 9.5379 25.3171 7.28976 +445 1 1.3832 3.4915 6.68441 -1.24784 -22.5622 2.29536 +446 1 2.09272 4.19927 6.89939 7.14914 10.3433 -0.646722 +447 1 2.38812 3.48925 7.75082 -1.53849 -4.15299 -0.56146 +448 1 0.98545 4.31304 7.66307 5.8465 7.34467 12.6645 +449 1 3.01955 3.30623 6.95327 13.2113 8.86686 7.49164 +450 1 4.09943 3.91395 7.09298 -2.48303 5.76893 1.33505 +451 1 4.01094 3.20608 7.89765 -2.70921 2.34384 1.12391 +452 1 3.37728 4.06259 7.97546 3.1883 6.31048 -16.9835 +453 1 4.95274 4.06193 6.44472 -50.262 -12.0969 -14.4258 +454 1 5.82886 4.19415 6.78586 51.8922 14.3443 21.8961 +455 1 5.38346 3.34165 7.34475 16.015 22.8896 8.36611 +456 1 5.08561 4.4601 7.63447 17.0994 -9.93497 -11.4722 +457 1 6.63523 3.51978 6.68288 11.156 -6.22589 -13.2585 +458 1 7.56324 4.26511 6.59456 -1.25309 2.63878 0.745103 +459 1 7.65852 3.28844 7.34661 -10.7372 -4.25374 3.64969 +460 1 6.81691 4.07739 7.53042 5.20496 31.087 -1.8792 +461 1 0.0305913 5.07954 6.63961 -13.4152 -0.334577 -15.0347 +462 1 0.755373 5.9128 6.63716 6.29428 -4.8245 9.83099 +463 1 0.228688 5.17338 7.63443 6.77209 -15.3569 2.77515 +464 1 0.0239769 6.1789 7.50959 5.71025 13.0173 8.45368 +465 1 1.62736 5.16876 6.26262 -1.95267 15.3222 16.2267 +466 1 2.58882 5.57631 6.81228 -21.3734 15.7914 -12.1527 +467 1 2.44828 4.86387 7.63128 0.635145 -14.9061 -0.714387 +468 1 1.59901 5.57209 7.51534 -11.1496 -3.28487 -5.03165 +469 1 3.34619 4.96263 7.08932 17.4571 -30.3367 -0.525226 +470 1 4.2543 5.71212 7.1129 9.72931 3.13017 -7.54215 +471 1 4.20945 4.90695 7.86069 -23.7666 -21.5851 -7.20856 +472 1 3.30097 5.87496 7.52978 -1.62077 18.6793 20.7743 +473 1 5.31869 5.1825 6.70313 -6.70115 -5.30598 20.424 +474 1 6.1285 5.9705 7.04356 -55.8752 -30.7828 -22.045 +475 1 6.19989 5.01385 7.64593 -24.2843 -27.8512 -0.0723503 +476 1 5.23737 5.71302 7.75618 7.88564 -2.82129 -5.95862 +477 1 6.57282 5.00818 6.64579 3.73801 7.56977 2.57742 +478 1 7.65968 6.07456 6.846 -10.6673 -6.72159 -16.2973 +479 1 7.41458 5.08419 7.34751 2.79575 -2.58892 1.26995 +480 1 6.72257 5.83109 7.80136 50.7146 16.6992 29.5346 +481 1 0.0723308 6.76891 6.47705 11.6111 8.10298 22.8191 +482 1 1.02933 7.74537 6.50218 -6.26193 -3.88943 1.15511 +483 1 0.947055 6.70337 7.58592 -5.51835 -14.0139 4.24362 +484 1 0.0848928 7.36532 7.45176 -1.87156 3.22591 1.0451 +485 1 1.56902 6.60766 6.76327 -14.013 -31.9293 15.0177 +486 1 2.40361 7.17234 6.95829 30.5527 12.991 8.35655 +487 1 2.29885 6.36291 7.58786 1.80834 5.53646 4.44151 +488 1 1.553 7.54602 7.43994 -8.27629 2.11355 -7.51923 +489 1 3.47111 6.73135 6.78593 -6.0772 1.66346 11.0677 +490 1 4.24975 7.49747 6.97664 2.8759 -9.15152 10.7243 +491 1 4.10179 6.68273 7.72108 -3.71491 1.8557 -11.1514 +492 1 3.18945 7.41445 7.81539 11.7129 -34.8369 22.2868 +493 1 5.09069 6.56162 6.92242 0.709322 1.72009 4.70344 +494 1 6.15914 7.53992 6.80488 -4.25562 -6.4834 8.29409 +495 1 6.17817 6.79535 7.72789 -19.4606 -0.130997 -26.8387 +496 1 5.10104 7.47088 7.65047 -2.76834 -2.47532 -11.4779 +497 1 6.74018 6.65599 6.74814 32.1985 25.9827 -14.7809 +498 1 7.41102 7.54832 6.72723 12.7336 -14.2037 26.5422 +499 1 7.28837 6.72521 7.66327 11.2322 2.95469 4.78999 +500 1 6.81386 7.67069 7.84231 -16.9841 5.08288 -4.95949 diff --git a/examples/mdi/dump.17Jun22.snapshot.driver.tcp.1 b/examples/mdi/dump.17Jun22.snapshot.driver.tcp.1 new file mode 100644 index 0000000000..c4ee904680 --- /dev/null +++ b/examples/mdi/dump.17Jun22.snapshot.driver.tcp.1 @@ -0,0 +1,2036 @@ +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +500 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +ITEM: ATOMS id type x y z f_2[1] f_2[2] f_2[3] +1 1 0 0 0 -1.06581e-14 -1.06581e-14 -1.00753e-14 +2 1 0.839798 0.839798 0 2.66454e-15 3.34455e-15 -9.76996e-15 +3 1 0.839798 0 0.839798 2.66454e-15 -1.05471e-14 4.56579e-15 +4 1 0 0.839798 0.839798 -1.15463e-14 2.88658e-15 3.44169e-15 +5 1 1.6796 0 0 -4.09395e-16 -9.76996e-15 -1.04361e-14 +6 1 2.51939 0.839798 0 -4.23273e-16 2.66454e-15 -1.06581e-14 +7 1 2.51939 0 0.839798 -7.00828e-16 -1.06581e-14 2.9976e-15 +8 1 1.6796 0.839798 0.839798 -4.3715e-16 3.10862e-15 3.1225e-15 +9 1 3.35919 0 0 1.28439e-14 -1.06581e-14 -1.04361e-14 +10 1 4.19899 0.839798 0 -2.25236e-14 2.66454e-15 -7.99361e-15 +11 1 4.19899 0 0.839798 -2.34118e-14 -8.88178e-15 2.55351e-15 +12 1 3.35919 0.839798 0.839798 1.37182e-14 3.10862e-15 4.23273e-15 +13 1 5.03879 0 0 2.77556e-17 -7.99361e-15 -7.99361e-15 +14 1 5.87859 0.839798 0 2.26555e-14 2.66454e-15 -7.99361e-15 +15 1 5.87859 0 0.839798 2.16702e-14 -7.99361e-15 2.66454e-15 +16 1 5.03879 0.839798 0.839798 -4.09395e-16 2.88658e-15 2.90046e-15 +17 1 6.71838 0 0 -3.33067e-15 -9.63118e-15 -9.74221e-15 +18 1 7.55818 0.839798 0 4.44089e-16 2.55351e-15 -9.32587e-15 +19 1 7.55818 0 0.839798 0 -1.02141e-14 3.21965e-15 +20 1 6.71838 0.839798 0.839798 -2.94209e-15 2.90046e-15 4.02456e-15 +21 1 0 1.6796 0 -1.15463e-14 0 -1.04361e-14 +22 1 0.839798 2.51939 0 2.88658e-15 -2.77556e-17 -9.76996e-15 +23 1 0.839798 1.6796 0.839798 2.33147e-15 2.22045e-16 3.34455e-15 +24 1 0 2.51939 0.839798 -1.06581e-14 -7.21645e-16 2.9976e-15 +25 1 1.6796 1.6796 0 -5.06539e-16 6.245e-17 -9.76996e-15 +26 1 2.51939 2.51939 0 -2.11636e-15 -1.72778e-15 -9.76996e-15 +27 1 2.51939 1.6796 0.839798 -1.2837e-15 9.08995e-16 2.88658e-15 +28 1 1.6796 2.51939 0.839798 3.53884e-16 -2.0331e-15 2.88658e-15 +29 1 3.35919 1.6796 0 1.34545e-14 3.46945e-17 -7.99361e-15 +30 1 4.19899 2.51939 0 -2.30926e-14 -1.85268e-15 -7.99361e-15 +31 1 4.19899 1.6796 0.839798 -2.24404e-14 -2.08167e-16 3.33067e-15 +32 1 3.35919 2.51939 0.839798 1.45925e-14 -1.36002e-15 3.33067e-15 +33 1 5.03879 1.6796 0 2.01228e-16 1.66533e-16 -7.10543e-15 +34 1 5.87859 2.51939 0 2.12677e-14 -1.74166e-15 -7.99361e-15 +35 1 5.87859 1.6796 0.839798 1.98383e-14 1.17961e-15 3.10862e-15 +36 1 5.03879 2.51939 0.839798 3.40006e-16 -2.80331e-15 2.88658e-15 +37 1 6.71838 1.6796 0 -3.10862e-15 -1.66533e-16 -8.10463e-15 +38 1 7.55818 2.51939 0 8.88178e-16 -1.33227e-15 -9.32587e-15 +39 1 7.55818 1.6796 0.839798 -8.04912e-16 1.94289e-16 3.33067e-15 +40 1 6.71838 2.51939 0.839798 -3.10862e-15 -1.66533e-15 3.56659e-15 +41 1 0 3.35919 0 -1.06581e-14 1.28786e-14 -9.54792e-15 +42 1 0.839798 4.19899 0 2.66454e-15 -2.24404e-14 -8.88178e-15 +43 1 0.839798 3.35919 0.839798 2.33147e-15 1.43774e-14 4.01068e-15 +44 1 0 4.19899 0.839798 -8.88178e-15 -2.32037e-14 2.55351e-15 +45 1 1.6796 3.35919 0 -8.53484e-16 1.47174e-14 -9.76996e-15 +46 1 2.51939 4.19899 0 -1.79717e-15 -2.32175e-14 -7.10543e-15 +47 1 2.51939 3.35919 0.839798 -5.06539e-16 1.51476e-14 3.55271e-15 +48 1 1.6796 4.19899 0.839798 -2.08167e-16 -2.40918e-14 3.33067e-15 +49 1 3.35919 3.35919 0 1.2608e-14 1.419e-14 -7.99361e-15 +50 1 4.19899 4.19899 0 -2.28706e-14 -2.25653e-14 -5.32907e-15 +51 1 4.19899 3.35919 0.839798 -2.21004e-14 1.13937e-14 2.88658e-15 +52 1 3.35919 4.19899 0.839798 1.249e-14 -2.21975e-14 2.88658e-15 +53 1 5.03879 3.35919 0 -2.22045e-16 1.14422e-14 -6.21725e-15 +54 1 5.87859 4.19899 0 2.22322e-14 -2.22461e-14 -5.32907e-15 +55 1 5.87859 3.35919 0.839798 2.14412e-14 1.27467e-14 2.88658e-15 +56 1 5.03879 4.19899 0.839798 -2.08167e-16 -2.11983e-14 3.10862e-15 +57 1 6.71838 3.35919 0 -3.60822e-15 1.32949e-14 -8.04912e-15 +58 1 7.55818 4.19899 0 8.88178e-16 -2.44249e-14 -7.10543e-15 +59 1 7.55818 3.35919 0.839798 1.66533e-16 1.40443e-14 3.10862e-15 +60 1 6.71838 4.19899 0.839798 -3.05311e-15 -2.40641e-14 2.45637e-15 +61 1 0 5.03879 0 -7.10543e-15 6.66134e-16 -7.32747e-15 +62 1 0.839798 5.87859 0 2.66454e-15 2.28706e-14 -7.10543e-15 +63 1 0.839798 5.03879 0.839798 2.55351e-15 -2.77556e-16 2.67841e-15 +64 1 0 5.87859 0.839798 -9.76996e-15 2.18159e-14 2.66454e-15 +65 1 1.6796 5.03879 0 8.32667e-17 -9.92262e-16 -6.21725e-15 +66 1 2.51939 5.87859 0 -2.08167e-15 2.16008e-14 -7.10543e-15 +67 1 2.51939 5.03879 0.839798 -1.72085e-15 3.81639e-16 3.10862e-15 +68 1 1.6796 5.87859 0.839798 -8.74301e-16 2.02824e-14 3.10862e-15 +69 1 3.35919 5.03879 0 1.08871e-14 -1.80411e-16 -6.21725e-15 +70 1 4.19899 5.87859 0 -2.27804e-14 2.17187e-14 -4.44089e-15 +71 1 4.19899 5.03879 0.839798 -1.95469e-14 -1.15186e-15 2.88658e-15 +72 1 3.35919 5.87859 0.839798 1.19973e-14 2.21143e-14 2.88658e-15 +73 1 5.03879 5.03879 0 1.17961e-16 6.8695e-16 -3.55271e-15 +74 1 5.87859 5.87859 0 2.17604e-14 2.22114e-14 -5.32907e-15 +75 1 5.87859 5.03879 0.839798 1.9415e-14 3.747e-16 2.88658e-15 +76 1 5.03879 5.87859 0.839798 -6.52256e-16 1.92069e-14 2.88658e-15 +77 1 6.71838 5.03879 0 -2.38698e-15 4.64906e-16 -6.43929e-15 +78 1 7.55818 5.87859 0 0 2.26485e-14 -7.54952e-15 +79 1 7.55818 5.03879 0.839798 1.11022e-16 1.44329e-15 2.498e-15 +80 1 6.71838 5.87859 0.839798 -2.94209e-15 2.15661e-14 2.45637e-15 +81 1 0 6.71838 0 -1.06581e-14 -3.77476e-15 -9.60343e-15 +82 1 0.839798 7.55818 0 2.44249e-15 7.91034e-16 -1.00892e-14 +83 1 0.839798 6.71838 0.839798 2.33147e-15 -2.83107e-15 3.80251e-15 +84 1 0 7.55818 0.839798 -8.88178e-15 -2.22045e-16 3.05311e-15 +85 1 1.6796 6.71838 0 -8.04912e-16 -1.72085e-15 -8.99281e-15 +86 1 2.51939 7.55818 0 -1.51268e-15 6.66134e-16 -9.54792e-15 +87 1 2.51939 6.71838 0.839798 -7.91034e-16 -2.83801e-15 3.56659e-15 +88 1 1.6796 7.55818 0.839798 2.08167e-16 2.77556e-16 3.33067e-15 +89 1 3.35919 6.71838 0 1.24623e-14 -2.22045e-15 -8.04912e-15 +90 1 4.19899 7.55818 0 -2.45221e-14 0 -7.99361e-15 +91 1 4.19899 6.71838 0.839798 -2.33563e-14 -4.89886e-15 2.45637e-15 +92 1 3.35919 7.55818 0.839798 1.30868e-14 8.88178e-16 2.88658e-15 +93 1 5.03879 6.71838 0 -4.02456e-16 -2.83107e-15 -6.43929e-15 +94 1 5.87859 7.55818 0 2.33563e-14 8.88178e-16 -7.10543e-15 +95 1 5.87859 6.71838 0.839798 2.1913e-14 -1.74166e-15 2.45637e-15 +96 1 5.03879 7.55818 0.839798 -2.08167e-16 -5.27356e-16 2.498e-15 +97 1 6.71838 6.71838 0 -2.83107e-15 -3.42781e-15 -7.10543e-15 +98 1 7.55818 7.55818 0 4.44089e-16 0 -8.88178e-15 +99 1 7.55818 6.71838 0.839798 5.55112e-17 -3.10862e-15 2.55351e-15 +100 1 6.71838 7.55818 0.839798 -2.88658e-15 5.27356e-16 2.56739e-15 +101 1 0 0 1.6796 -1.15463e-14 -1.04361e-14 -1.11022e-15 +102 1 0.839798 0.839798 1.6796 2.44249e-15 2.56739e-15 6.66134e-16 +103 1 0.839798 0 2.51939 2.66454e-15 -1.05471e-14 1.80411e-16 +104 1 0 0.839798 2.51939 -1.15463e-14 2.9976e-15 3.88578e-16 +105 1 1.6796 0 1.6796 1.73472e-16 -9.76996e-15 0 +106 1 2.51939 0.839798 1.6796 -1.71391e-15 2.66454e-15 3.88578e-16 +107 1 2.51939 0 2.51939 -1.6584e-15 -1.06581e-14 -1.4988e-15 +108 1 1.6796 0.839798 2.51939 2.63678e-16 3.10862e-15 -1.67227e-15 +109 1 3.35919 0 1.6796 1.41623e-14 -8.88178e-15 6.66134e-16 +110 1 4.19899 0.839798 1.6796 -2.18159e-14 2.44249e-15 -6.10623e-16 +111 1 4.19899 0 2.51939 -2.30371e-14 -7.99361e-15 -1.66533e-15 +112 1 3.35919 0.839798 2.51939 1.4419e-14 2.88658e-15 -1.90126e-15 +113 1 5.03879 0 1.6796 8.67362e-16 -8.88178e-15 8.88178e-16 +114 1 5.87859 0.839798 1.6796 2.02685e-14 2.44249e-15 1.02696e-15 +115 1 5.87859 0 2.51939 2.01159e-14 -8.88178e-15 -1.38778e-15 +116 1 5.03879 0.839798 2.51939 2.91434e-16 3.10862e-15 -1.45023e-15 +117 1 6.71838 0 1.6796 -2.52576e-15 -8.77076e-15 -9.02056e-17 +118 1 7.55818 0.839798 1.6796 3.747e-16 2.16493e-15 1.04083e-16 +119 1 7.55818 0 2.51939 1.33227e-15 -9.76996e-15 -1.9984e-15 +120 1 6.71838 0.839798 2.51939 -3.10862e-15 2.90046e-15 -2.10942e-15 +121 1 0 1.6796 1.6796 -1.28786e-14 8.88178e-16 6.66134e-16 +122 1 0.839798 2.51939 1.6796 2.33147e-15 -1.43635e-15 1.11022e-16 +123 1 0.839798 1.6796 2.51939 2.66454e-15 7.35523e-16 -1.30451e-15 +124 1 0 2.51939 2.51939 -1.06581e-14 -7.49401e-16 -1.44329e-15 +125 1 1.6796 1.6796 1.6796 2.22045e-16 -1.67921e-15 5.96745e-16 +126 1 2.51939 2.51939 1.6796 -8.95117e-16 -2.39392e-15 -1.3739e-15 +127 1 2.51939 1.6796 2.51939 -9.22873e-16 1.38778e-17 -1.17267e-15 +128 1 1.6796 2.51939 2.51939 1.38778e-16 -1.26982e-15 -2.16493e-15 +129 1 3.35919 1.6796 1.6796 1.44329e-14 -1.58207e-15 5.27356e-16 +130 1 4.19899 2.51939 1.6796 -2.17534e-14 -1.89432e-15 -4.85723e-16 +131 1 4.19899 1.6796 2.51939 -2.2024e-14 4.64906e-16 -2.11636e-15 +132 1 3.35919 2.51939 2.51939 1.47937e-14 -1.33227e-15 -2.23432e-15 +133 1 5.03879 1.6796 1.6796 6.38378e-16 -4.78784e-16 8.46545e-16 +134 1 5.87859 2.51939 1.6796 2.05322e-14 -1.4086e-15 2.28983e-16 +135 1 5.87859 1.6796 2.51939 2.02546e-14 -2.56739e-16 -2.07473e-15 +136 1 5.03879 2.51939 2.51939 5.82867e-16 -1.91513e-15 -2.16493e-15 +137 1 6.71838 1.6796 1.6796 -2.16493e-15 -9.4369e-16 5.55112e-17 +138 1 7.55818 2.51939 1.6796 -4.44089e-16 -1.11022e-15 -2.77556e-17 +139 1 7.55818 1.6796 2.51939 4.44089e-16 -6.93889e-18 -2.22045e-15 +140 1 6.71838 2.51939 2.51939 -3.27516e-15 -1.67921e-15 -2.38698e-15 +141 1 0 3.35919 1.6796 -1.11022e-14 1.39888e-14 -2.22045e-16 +142 1 0.839798 4.19899 1.6796 2.44249e-15 -2.1684e-14 -6.10623e-16 +143 1 0.839798 3.35919 2.51939 2.44249e-15 1.49047e-14 -1.83187e-15 +144 1 0 4.19899 2.51939 -8.88178e-15 -2.22322e-14 -1.60982e-15 +145 1 1.6796 3.35919 1.6796 2.08167e-16 1.37251e-14 5.41234e-16 +146 1 2.51939 4.19899 1.6796 -1.72778e-15 -2.28081e-14 -1.32533e-15 +147 1 2.51939 3.35919 2.51939 -9.92262e-16 1.42247e-14 -1.29757e-15 +148 1 1.6796 4.19899 2.51939 6.93889e-18 -2.16632e-14 -2.92821e-15 +149 1 3.35919 3.35919 1.6796 1.39194e-14 1.31006e-14 3.46945e-16 +150 1 4.19899 4.19899 1.6796 -2.1684e-14 -2.2142e-14 -1.26982e-15 +151 1 4.19899 3.35919 2.51939 -2.27457e-14 1.10675e-14 -2.81025e-15 +152 1 3.35919 4.19899 2.51939 1.17337e-14 -2.23849e-14 -3.15026e-15 +153 1 5.03879 3.35919 1.6796 -6.93889e-18 1.12688e-14 1.38778e-16 +154 1 5.87859 4.19899 1.6796 2.0213e-14 -2.25167e-14 2.28983e-16 +155 1 5.87859 3.35919 2.51939 2.08236e-14 1.21292e-14 -2.5327e-15 +156 1 5.03879 4.19899 2.51939 1.38778e-17 -1.97481e-14 -3.59435e-15 +157 1 6.71838 3.35919 1.6796 -2.96291e-15 1.29619e-14 -1.11716e-15 +158 1 7.55818 4.19899 1.6796 2.22045e-16 -2.33147e-14 -4.996e-16 +159 1 7.55818 3.35919 2.51939 1.33227e-15 1.33227e-14 -2.66454e-15 +160 1 6.71838 4.19899 2.51939 -3.27516e-15 -2.33147e-14 -2.84495e-15 +161 1 0 5.03879 1.6796 -7.10543e-15 4.44089e-16 0 +162 1 0.839798 5.87859 1.6796 2.44249e-15 2.08375e-14 7.21645e-16 +163 1 0.839798 5.03879 2.51939 2.88658e-15 2.63678e-16 -1.13798e-15 +164 1 0 5.87859 2.51939 -7.99361e-15 2.03171e-14 -1.44329e-15 +165 1 1.6796 5.03879 1.6796 2.56739e-16 8.60423e-16 8.04912e-16 +166 1 2.51939 5.87859 1.6796 -9.64506e-16 2.08375e-14 -7.35523e-16 +167 1 2.51939 5.03879 2.51939 -2.04003e-15 -4.57967e-16 -2.84495e-16 +168 1 1.6796 5.87859 2.51939 6.93889e-18 2.03101e-14 -7.91034e-16 +169 1 3.35919 5.03879 1.6796 1.12549e-14 2.08167e-17 1.08247e-15 +170 1 4.19899 5.87859 1.6796 -2.15591e-14 2.06987e-14 9.57567e-16 +171 1 4.19899 5.03879 2.51939 -1.96579e-14 4.30211e-16 -2.72699e-15 +172 1 3.35919 5.87859 2.51939 1.23929e-14 2.06432e-14 -2.2482e-15 +173 1 5.03879 5.03879 1.6796 2.77556e-17 -1.38778e-16 1.20737e-15 +174 1 5.87859 5.87859 1.6796 2.07542e-14 2.02408e-14 7.70217e-16 +175 1 5.87859 5.03879 2.51939 1.86587e-14 6.52256e-16 -1.7833e-15 +176 1 5.03879 5.87859 2.51939 -2.08167e-16 1.92762e-14 -1.33227e-15 +177 1 6.71838 5.03879 1.6796 -2.42167e-15 -1.31839e-16 -3.33067e-16 +178 1 7.55818 5.87859 1.6796 -2.22045e-16 2.19824e-14 2.22045e-16 +179 1 7.55818 5.03879 2.51939 -4.44089e-16 1.22125e-15 -1.9984e-15 +180 1 6.71838 5.87859 2.51939 -3.10862e-15 2.20657e-14 -2.19269e-15 +181 1 0 6.71838 1.6796 -1.02141e-14 -2.88658e-15 -6.66134e-16 +182 1 0.839798 7.55818 1.6796 1.9984e-15 6.38378e-16 2.22045e-16 +183 1 0.839798 6.71838 2.51939 2.66454e-15 -3.10862e-15 -2.08167e-15 +184 1 0 7.55818 2.51939 -9.76996e-15 4.44089e-16 -1.88738e-15 +185 1 1.6796 6.71838 1.6796 1.94289e-16 -2.31759e-15 1.249e-16 +186 1 2.51939 7.55818 1.6796 -1.249e-15 -6.17562e-16 5.55112e-17 +187 1 2.51939 6.71838 2.51939 -1.19349e-15 -3.10862e-15 -2.08167e-15 +188 1 1.6796 7.55818 2.51939 -2.22045e-16 1.33227e-15 -2.66454e-15 +189 1 3.35919 6.71838 1.6796 1.34198e-14 -2.02616e-15 -6.245e-17 +190 1 4.19899 7.55818 1.6796 -2.38282e-14 -4.71845e-16 1.45717e-16 +191 1 4.19899 6.71838 2.51939 -2.43278e-14 -4.60743e-15 -3.88578e-15 +192 1 3.35919 7.55818 2.51939 1.29896e-14 1.9984e-15 -2.22045e-15 +193 1 5.03879 6.71838 1.6796 -6.245e-17 -1.65146e-15 2.35922e-16 +194 1 5.87859 7.55818 1.6796 2.23294e-14 1.13798e-15 -6.93889e-18 +195 1 5.87859 6.71838 2.51939 2.15869e-14 -2.9976e-15 -2.63678e-15 +196 1 5.03879 7.55818 2.51939 -2.22045e-16 -2.22045e-16 -1.77636e-15 +197 1 6.71838 6.71838 1.6796 -2.62984e-15 -2.59515e-15 -1.47798e-15 +198 1 7.55818 7.55818 1.6796 4.44089e-16 2.22045e-16 -8.32667e-17 +199 1 7.55818 6.71838 2.51939 8.88178e-16 -2.27596e-15 -2.66454e-15 +200 1 6.71838 7.55818 2.51939 -2.9976e-15 7.91034e-16 -1.91513e-15 +201 1 0 0 3.35919 -1.06581e-14 -1.04361e-14 1.35447e-14 +202 1 0.839798 0.839798 3.35919 2.66454e-15 2.67841e-15 1.50435e-14 +203 1 0.839798 0 4.19899 2.66454e-15 -8.77076e-15 -2.26139e-14 +204 1 0 0.839798 4.19899 -8.88178e-15 2.88658e-15 -2.24265e-14 +205 1 1.6796 0 3.35919 1.73472e-16 -8.88178e-15 1.42109e-14 +206 1 2.51939 0.839798 3.35919 -1.83881e-15 2.77556e-15 1.55431e-14 +207 1 2.51939 0 4.19899 -1.67227e-15 -7.99361e-15 -2.32037e-14 +208 1 1.6796 0.839798 4.19899 -1.8735e-16 3.33067e-15 -2.28637e-14 +209 1 3.35919 0 3.35919 1.37182e-14 -7.99361e-15 1.44329e-14 +210 1 4.19899 0.839798 3.35919 -2.30232e-14 2.66454e-15 1.19071e-14 +211 1 4.19899 0 4.19899 -2.27665e-14 -5.32907e-15 -2.27041e-14 +212 1 3.35919 0.839798 4.19899 1.24276e-14 2.88658e-15 -2.27457e-14 +213 1 5.03879 0 3.35919 -2.08167e-17 -7.99361e-15 1.11022e-14 +214 1 5.87859 0.839798 3.35919 2.2489e-14 2.55351e-15 1.36002e-14 +215 1 5.87859 0 4.19899 2.21143e-14 -5.32907e-15 -2.24265e-14 +216 1 5.03879 0.839798 4.19899 -1.08941e-15 3.55271e-15 -2.22461e-14 +217 1 6.71838 0 3.35919 -2.47025e-15 -8.77076e-15 1.29619e-14 +218 1 7.55818 0.839798 3.35919 -1.11022e-15 2.60902e-15 1.4766e-14 +219 1 7.55818 0 4.19899 1.33227e-15 -6.43929e-15 -2.4647e-14 +220 1 6.71838 0.839798 4.19899 -2.38698e-15 2.67841e-15 -2.39531e-14 +221 1 0 1.6796 3.35919 -1.11022e-14 -2.22045e-16 1.44329e-14 +222 1 0.839798 2.51939 3.35919 2.77556e-15 -4.64906e-16 1.52378e-14 +223 1 0.839798 1.6796 4.19899 2.88658e-15 2.498e-16 -2.32592e-14 +224 1 0 2.51939 4.19899 -8.88178e-15 -1.60982e-15 -2.32592e-14 +225 1 1.6796 1.6796 3.35919 2.22045e-16 -7.91034e-16 1.5779e-14 +226 1 2.51939 2.51939 3.35919 -1.4086e-15 -1.02002e-15 1.46133e-14 +227 1 2.51939 1.6796 4.19899 -1.39472e-15 3.95517e-16 -2.30857e-14 +228 1 1.6796 2.51939 4.19899 -8.67362e-16 -1.45023e-15 -2.42237e-14 +229 1 3.35919 1.6796 3.35919 1.39888e-14 -2.77556e-17 1.57235e-14 +230 1 4.19899 2.51939 3.35919 -2.32939e-14 -1.64452e-15 1.24276e-14 +231 1 4.19899 1.6796 4.19899 -2.19755e-14 -9.08995e-16 -2.30302e-14 +232 1 3.35919 2.51939 4.19899 1.17822e-14 -2.00534e-15 -2.40433e-14 +233 1 5.03879 1.6796 3.35919 -2.498e-16 -9.22873e-16 1.29757e-14 +234 1 5.87859 2.51939 3.35919 2.13649e-14 -8.67362e-16 1.27398e-14 +235 1 5.87859 1.6796 4.19899 2.08236e-14 -7.42462e-16 -2.31828e-14 +236 1 5.03879 2.51939 4.19899 -4.30211e-16 -1.67227e-15 -2.22253e-14 +237 1 6.71838 1.6796 3.35919 -3.19883e-15 -4.996e-16 1.39264e-14 +238 1 7.55818 2.51939 3.35919 -4.44089e-16 -1.9984e-15 1.24345e-14 +239 1 7.55818 1.6796 4.19899 -4.44089e-16 -5.06539e-16 -2.39808e-14 +240 1 6.71838 2.51939 4.19899 -2.44249e-15 -1.47105e-15 -2.40641e-14 +241 1 0 3.35919 3.35919 -1.11022e-14 1.33227e-14 1.31006e-14 +242 1 0.839798 4.19899 3.35919 2.66454e-15 -2.26555e-14 1.12133e-14 +243 1 0.839798 3.35919 4.19899 2.44249e-15 1.28925e-14 -2.26208e-14 +244 1 0 4.19899 4.19899 -6.21725e-15 -2.26485e-14 -2.26485e-14 +245 1 1.6796 3.35919 3.35919 2.08167e-16 1.3281e-14 1.52794e-14 +246 1 2.51939 4.19899 3.35919 -2.17187e-15 -2.33494e-14 1.22957e-14 +247 1 2.51939 3.35919 4.19899 -1.94983e-15 1.21569e-14 -2.20726e-14 +248 1 1.6796 4.19899 4.19899 -5.20417e-16 -2.2489e-14 -2.38767e-14 +249 1 3.35919 3.35919 3.35919 1.28092e-14 1.24345e-14 1.42109e-14 +250 1 4.19899 4.19899 3.35919 -2.29677e-14 -2.35575e-14 8.33361e-15 +251 1 4.19899 3.35919 4.19899 -2.33702e-14 9.08301e-15 -2.33355e-14 +252 1 3.35919 4.19899 4.19899 9.67976e-15 -2.36547e-14 -2.46539e-14 +253 1 5.03879 3.35919 3.35919 -2.28983e-16 1.06026e-14 1.14353e-14 +254 1 5.87859 4.19899 3.35919 2.19408e-14 -2.21698e-14 8.51402e-15 +255 1 5.87859 3.35919 4.19899 2.15522e-14 1.01238e-14 -2.328e-14 +256 1 5.03879 4.19899 4.19899 -5.20417e-16 -2.11775e-14 -2.23085e-14 +257 1 6.71838 3.35919 3.35919 -3.1225e-15 1.22957e-14 1.31978e-14 +258 1 7.55818 4.19899 3.35919 -1.11022e-15 -2.4647e-14 1.05471e-14 +259 1 7.55818 3.35919 4.19899 -8.88178e-16 1.113e-14 -2.53131e-14 +260 1 6.71838 4.19899 4.19899 -3.60822e-15 -2.5091e-14 -2.32731e-14 +261 1 0 5.03879 3.35919 -7.10543e-15 -2.22045e-16 1.15463e-14 +262 1 0.839798 5.87859 3.35919 2.55351e-15 2.28359e-14 1.37113e-14 +263 1 0.839798 5.03879 4.19899 2.88658e-15 -1.05471e-15 -2.20102e-14 +264 1 0 5.87859 4.19899 -5.32907e-15 2.21212e-14 -2.25375e-14 +265 1 1.6796 5.03879 3.35919 2.56739e-16 -2.498e-16 1.26843e-14 +266 1 2.51939 5.87859 3.35919 -1.31145e-15 2.16702e-14 1.30659e-14 +267 1 2.51939 5.03879 4.19899 -2.06085e-15 8.04912e-16 -2.10873e-14 +268 1 1.6796 5.87859 4.19899 -7.63278e-17 2.17118e-14 -2.12261e-14 +269 1 3.35919 5.03879 3.35919 1.10328e-14 -2.01228e-16 1.11994e-14 +270 1 4.19899 5.87859 3.35919 -2.29886e-14 2.15314e-14 1.08039e-14 +271 1 4.19899 5.03879 4.19899 -2.02338e-14 -4.92661e-16 -2.14065e-14 +272 1 3.35919 5.87859 4.19899 1.03459e-14 2.19963e-14 -2.39878e-14 +273 1 5.03879 5.03879 3.35919 -1.94289e-16 -8.04912e-16 8.64586e-15 +274 1 5.87859 5.87859 3.35919 2.18645e-14 2.20171e-14 1.02141e-14 +275 1 5.87859 5.03879 4.19899 1.98036e-14 1.38778e-16 -2.15869e-14 +276 1 5.03879 5.87859 4.19899 -3.05311e-16 1.94428e-14 -2.04628e-14 +277 1 6.71838 5.03879 3.35919 -2.35922e-15 -3.53884e-16 1.02071e-14 +278 1 7.55818 5.87859 3.35919 -8.88178e-16 2.28706e-14 1.02141e-14 +279 1 7.55818 5.03879 4.19899 -1.33227e-15 -3.05311e-16 -2.33147e-14 +280 1 6.71838 5.87859 4.19899 -3.27516e-15 2.23987e-14 -2.53547e-14 +281 1 0 6.71838 3.35919 -9.32587e-15 -3.77476e-15 1.31006e-14 +282 1 0.839798 7.55818 3.35919 2.33147e-15 1.13798e-15 1.40166e-14 +283 1 0.839798 6.71838 4.19899 2.66454e-15 -2.44249e-15 -2.37865e-14 +284 1 0 7.55818 4.19899 -6.21725e-15 -2.22045e-16 -2.50355e-14 +285 1 1.6796 6.71838 3.35919 1.94289e-16 -2.25514e-15 1.4419e-14 +286 1 2.51939 7.55818 3.35919 -1.59595e-15 -6.10623e-16 1.37668e-14 +287 1 2.51939 6.71838 4.19899 -8.95117e-16 -2.55351e-15 -2.28983e-14 +288 1 1.6796 7.55818 4.19899 -5.13478e-16 8.88178e-16 -2.44249e-14 +289 1 3.35919 6.71838 3.35919 1.20876e-14 -2.85189e-15 1.31353e-14 +290 1 4.19899 7.55818 3.35919 -2.47094e-14 -9.4369e-16 1.06026e-14 +291 1 4.19899 6.71838 4.19899 -2.41057e-14 -3.77476e-15 -2.26208e-14 +292 1 3.35919 7.55818 4.19899 1.06998e-14 1.55431e-15 -2.53131e-14 +293 1 5.03879 6.71838 3.35919 -6.245e-17 -3.36536e-15 1.00892e-14 +294 1 5.87859 7.55818 3.35919 2.328e-14 4.44089e-16 1.02696e-14 +295 1 5.87859 6.71838 4.19899 2.31135e-14 -3.33067e-15 -2.39531e-14 +296 1 5.03879 7.55818 4.19899 -6.93889e-17 2.22045e-16 -2.28706e-14 +297 1 6.71838 6.71838 3.35919 -2.63678e-15 -2.97679e-15 1.21014e-14 +298 1 7.55818 7.55818 3.35919 -4.44089e-16 2.22045e-16 1.2268e-14 +299 1 7.55818 6.71838 4.19899 0 -2.94209e-15 -2.70894e-14 +300 1 6.71838 7.55818 4.19899 -3.10862e-15 9.57567e-16 -2.65621e-14 +301 1 0 0 5.03879 -7.99361e-15 -7.77156e-15 6.66134e-16 +302 1 0.839798 0.839798 5.03879 2.44249e-15 2.56739e-15 2.22045e-16 +303 1 0.839798 0 5.87859 2.88658e-15 -7.88258e-15 2.30926e-14 +304 1 0 0.839798 5.87859 -8.88178e-15 2.88658e-15 2.23155e-14 +305 1 1.6796 0 5.03879 -3.67761e-16 -8.88178e-15 -6.66134e-16 +306 1 2.51939 0.839798 5.03879 -1.26982e-15 2.66454e-15 8.60423e-16 +307 1 2.51939 0 5.87859 -2.08167e-15 -7.99361e-15 2.15383e-14 +308 1 1.6796 0.839798 5.87859 2.63678e-16 2.88658e-15 2.07612e-14 +309 1 3.35919 0 5.03879 1.09704e-14 -7.10543e-15 1.11022e-15 +310 1 4.19899 0.839798 5.03879 -2.02546e-14 2.66454e-15 -4.996e-16 +311 1 4.19899 0 5.87859 -2.26694e-14 -5.32907e-15 2.09832e-14 +312 1 3.35919 0.839798 5.87859 1.21708e-14 2.88658e-15 2.16979e-14 +313 1 5.03879 0 5.03879 -3.1225e-16 -5.32907e-15 2.22045e-16 +314 1 5.87859 0.839798 5.03879 1.91652e-14 2.77556e-15 1.9984e-15 +315 1 5.87859 0 5.87859 2.18436e-14 -4.44089e-15 2.27041e-14 +316 1 5.03879 0.839798 5.87859 -3.747e-16 3.10862e-15 2.10387e-14 +317 1 6.71838 0 5.03879 -3.30291e-15 -5.27356e-15 8.32667e-17 +318 1 7.55818 0.839798 5.03879 -1.11022e-16 2.41474e-15 1.66533e-15 +319 1 7.55818 0 5.87859 8.88178e-16 -7.32747e-15 2.33147e-14 +320 1 6.71838 0.839798 5.87859 -2.27596e-15 2.67841e-15 2.30926e-14 +321 1 0 1.6796 5.03879 -7.99361e-15 -6.66134e-16 2.22045e-16 +322 1 0.839798 2.51939 5.03879 2.44249e-15 -1.1588e-15 5.82867e-16 +323 1 0.839798 1.6796 5.87859 2.66454e-15 7.35523e-16 2.19269e-14 +324 1 0 2.51939 5.87859 -7.99361e-15 -1.83187e-15 2.15938e-14 +325 1 1.6796 1.6796 5.03879 2.01228e-16 -5.27356e-16 1.97065e-15 +326 1 2.51939 2.51939 5.03879 -1.00614e-15 -1.22818e-15 4.16334e-17 +327 1 2.51939 1.6796 5.87859 -9.99201e-16 -1.38778e-17 2.22808e-14 +328 1 1.6796 2.51939 5.87859 1.52656e-16 -1.38778e-15 2.04003e-14 +329 1 3.35919 1.6796 5.03879 1.17545e-14 2.63678e-16 1.02696e-15 +330 1 4.19899 2.51939 5.03879 -2.02893e-14 -2.11636e-15 -4.30211e-16 +331 1 4.19899 1.6796 5.87859 -2.20032e-14 -9.02056e-16 2.10318e-14 +332 1 3.35919 2.51939 5.87859 1.25316e-14 -1.51962e-15 2.06363e-14 +333 1 5.03879 1.6796 5.03879 8.88178e-16 -5.6205e-16 2.7478e-15 +334 1 5.87859 2.51939 5.03879 1.8846e-14 -7.84095e-16 1.20737e-15 +335 1 5.87859 1.6796 5.87859 2.0664e-14 -1.14492e-15 2.01852e-14 +336 1 5.03879 2.51939 5.87859 3.60822e-16 -1.94289e-15 1.76248e-14 +337 1 6.71838 1.6796 5.03879 -3.08781e-15 -8.74301e-16 5.96745e-16 +338 1 7.55818 2.51939 5.03879 -2.22045e-16 -1.55431e-15 2.22045e-16 +339 1 7.55818 1.6796 5.87859 1.77636e-15 -9.08995e-16 2.19824e-14 +340 1 6.71838 2.51939 5.87859 -2.60902e-15 -1.94289e-15 2.10665e-14 +341 1 0 3.35919 5.03879 -8.88178e-15 1.06581e-14 4.44089e-16 +342 1 0.839798 4.19899 5.03879 2.77556e-15 -2.00534e-14 -9.71445e-16 +343 1 0.839798 3.35919 5.87859 2.66454e-15 1.26565e-14 2.26763e-14 +344 1 0 4.19899 5.87859 -7.10543e-15 -2.27318e-14 2.12053e-14 +345 1 1.6796 3.35919 5.03879 2.15106e-16 1.11022e-14 1.249e-15 +346 1 2.51939 4.19899 5.03879 -1.61676e-15 -2.07542e-14 8.32667e-17 +347 1 2.51939 3.35919 5.87859 -1.34615e-15 1.1921e-14 2.25445e-14 +348 1 1.6796 4.19899 5.87859 -8.74301e-16 -2.1684e-14 1.93387e-14 +349 1 3.35919 3.35919 5.03879 1.08247e-14 1.05055e-14 6.245e-16 +350 1 4.19899 4.19899 5.03879 -2.08722e-14 -2.192e-14 5.55112e-16 +351 1 4.19899 3.35919 5.87859 -2.34326e-14 9.83241e-15 2.01436e-14 +352 1 3.35919 4.19899 5.87859 9.61037e-15 -2.29053e-14 2.15591e-14 +353 1 5.03879 3.35919 5.03879 6.31439e-16 6.7446e-15 5.41234e-16 +354 1 5.87859 4.19899 5.03879 1.91375e-14 -2.03101e-14 2.498e-16 +355 1 5.87859 3.35919 5.87859 2.14412e-14 1.00198e-14 2.06293e-14 +356 1 5.03879 4.19899 5.87859 -2.01228e-16 -2.06224e-14 1.59386e-14 +357 1 6.71838 3.35919 5.03879 -3.02536e-15 9.69363e-15 4.85723e-17 +358 1 7.55818 4.19899 5.03879 -8.88178e-16 -2.28706e-14 -3.33067e-16 +359 1 7.55818 3.35919 5.87859 4.44089e-16 1.11855e-14 2.30926e-14 +360 1 6.71838 4.19899 5.87859 -3.44169e-15 -2.34396e-14 2.11914e-14 +361 1 0 5.03879 5.03879 -3.9968e-15 -6.66134e-16 4.44089e-16 +362 1 0.839798 5.87859 5.03879 2.66454e-15 1.93595e-14 5.55112e-16 +363 1 0.839798 5.03879 5.87859 3.10862e-15 -4.02456e-16 2.03726e-14 +364 1 0 5.87859 5.87859 -5.32907e-15 2.18159e-14 2.27596e-14 +365 1 1.6796 5.03879 5.03879 2.77556e-17 4.16334e-17 1.3739e-15 +366 1 2.51939 5.87859 5.03879 -1.56125e-15 1.82285e-14 1.76248e-15 +367 1 2.51939 5.03879 5.87859 -2.04003e-15 -1.1241e-15 1.95052e-14 +368 1 1.6796 5.87859 5.87859 2.08167e-17 2.11636e-14 2.05252e-14 +369 1 3.35919 5.03879 5.03879 8.17402e-15 3.40006e-16 3.33067e-16 +370 1 4.19899 5.87859 5.03879 -2.08653e-14 1.81868e-14 3.26128e-16 +371 1 4.19899 5.03879 5.87859 -2.05391e-14 -2.28983e-16 1.85199e-14 +372 1 3.35919 5.87859 5.87859 1.02834e-14 2.14967e-14 2.09693e-14 +373 1 5.03879 5.03879 5.03879 2.35922e-16 2.498e-16 -1.30451e-15 +374 1 5.87859 5.87859 5.03879 1.90889e-14 1.87003e-14 -2.70617e-16 +375 1 5.87859 5.03879 5.87859 1.91305e-14 8.74301e-16 1.98105e-14 +376 1 5.03879 5.87859 5.87859 1.38778e-17 1.92832e-14 1.88183e-14 +377 1 6.71838 5.03879 5.03879 -3.45557e-15 -3.05311e-16 1.51962e-15 +378 1 7.55818 5.87859 5.03879 -4.44089e-16 2.08722e-14 1.66533e-16 +379 1 7.55818 5.03879 5.87859 -1.33227e-15 5.55112e-16 2.08722e-14 +380 1 6.71838 5.87859 5.87859 -3.33067e-15 2.20102e-14 2.08999e-14 +381 1 0 6.71838 5.03879 -7.54952e-15 -4.44089e-15 8.88178e-16 +382 1 0.839798 7.55818 5.03879 2.33147e-15 4.71845e-16 9.15934e-16 +383 1 0.839798 6.71838 5.87859 2.88658e-15 -2.27596e-15 2.23016e-14 +384 1 0 7.55818 5.87859 -6.21725e-15 -2.22045e-16 2.31482e-14 +385 1 1.6796 6.71838 5.03879 -1.38778e-17 -2.86576e-15 1.27676e-15 +386 1 2.51939 7.55818 5.03879 -1.51268e-15 -8.32667e-16 6.66134e-16 +387 1 2.51939 6.71838 5.87859 -1.32533e-15 -2.27596e-15 2.22322e-14 +388 1 1.6796 7.55818 5.87859 -2.498e-16 1.77636e-15 2.13163e-14 +389 1 3.35919 6.71838 5.03879 1.05402e-14 -3.47639e-15 2.19963e-15 +390 1 4.19899 7.55818 5.03879 -2.27665e-14 -1.44329e-15 8.32667e-16 +391 1 4.19899 6.71838 5.87859 -2.39184e-14 -2.94209e-15 2.11775e-14 +392 1 3.35919 7.55818 5.87859 1.08802e-14 1.55431e-15 2.28706e-14 +393 1 5.03879 6.71838 5.03879 -7.63278e-17 -4.04538e-15 1.38778e-17 +394 1 5.87859 7.55818 5.03879 2.10457e-14 -7.21645e-16 7.21645e-16 +395 1 5.87859 6.71838 5.87859 2.31065e-14 -3.10862e-15 2.18714e-14 +396 1 5.03879 7.55818 5.87859 1.38778e-17 -4.44089e-16 2.08722e-14 +397 1 6.71838 6.71838 5.03879 -2.76168e-15 -2.74086e-15 -3.88578e-16 +398 1 7.55818 7.55818 5.03879 0 0 -6.66134e-16 +399 1 7.55818 6.71838 5.87859 0 -2.94209e-15 2.39808e-14 +400 1 6.71838 7.55818 5.87859 -3.16414e-15 7.77156e-16 2.42029e-14 +401 1 0 0 6.71838 -1.06581e-14 -1.04361e-14 -3.77476e-15 +402 1 0.839798 0.839798 6.71838 2.66454e-15 2.67841e-15 -2.72005e-15 +403 1 0.839798 0 7.55818 2.55351e-15 -9.70057e-15 1.05471e-15 +404 1 0 0.839798 7.55818 -8.88178e-15 2.66454e-15 4.44089e-16 +405 1 1.6796 0 6.71838 2.08167e-16 -7.99361e-15 -2.44249e-15 +406 1 2.51939 0.839798 6.71838 -1.8735e-15 2.77556e-15 -2.72005e-15 +407 1 2.51939 0 7.55818 -1.56819e-15 -8.88178e-15 0 +408 1 1.6796 0.839798 7.55818 -1.11022e-16 2.66454e-15 1.55431e-15 +409 1 3.35919 0 6.71838 1.26288e-14 -7.10543e-15 -2.88658e-15 +410 1 4.19899 0.839798 6.71838 -2.40641e-14 2.66454e-15 -4.69069e-15 +411 1 4.19899 0 7.55818 -2.43069e-14 -7.99361e-15 -4.44089e-16 +412 1 3.35919 0.839798 7.55818 1.38223e-14 2.66454e-15 1.33227e-15 +413 1 5.03879 0 6.71838 2.22045e-16 -6.21725e-15 -3.10862e-15 +414 1 5.87859 0.839798 6.71838 2.22183e-14 2.55351e-15 -1.4988e-15 +415 1 5.87859 0 7.55818 2.35922e-14 -6.21725e-15 -8.88178e-16 +416 1 5.03879 0.839798 7.55818 -4.71845e-16 2.55351e-15 -2.77556e-17 +417 1 6.71838 0 6.71838 -3.38618e-15 -6.99441e-15 -3.94129e-15 +418 1 7.55818 0.839798 6.71838 -1.16573e-15 2.60902e-15 -3.10862e-15 +419 1 7.55818 0 7.55818 -4.44089e-16 -8.65974e-15 -8.88178e-16 +420 1 6.71838 0.839798 7.55818 -2.27596e-15 2.45637e-15 0 +421 1 0 1.6796 6.71838 -1.02141e-14 -4.44089e-16 -3.33067e-15 +422 1 0.839798 2.51939 6.71838 2.77556e-15 -4.996e-16 -3.05311e-15 +423 1 0.839798 1.6796 7.55818 2.66454e-15 1.11022e-16 -1.66533e-16 +424 1 0 2.51939 7.55818 -7.99361e-15 -1.76248e-15 -2.22045e-16 +425 1 1.6796 1.6796 6.71838 2.08167e-16 -7.63278e-16 -2.31759e-15 +426 1 2.51939 2.51939 6.71838 -1.38778e-15 -9.99201e-16 -2.73392e-15 +427 1 2.51939 1.6796 7.55818 -1.47105e-15 5.55112e-17 7.14706e-16 +428 1 1.6796 2.51939 7.55818 -3.33067e-16 -2.06779e-15 -1.45717e-16 +429 1 3.35919 1.6796 6.71838 1.30312e-14 -6.93889e-18 -2.52576e-15 +430 1 4.19899 2.51939 6.71838 -2.37796e-14 -2.35922e-15 -4.35069e-15 +431 1 4.19899 1.6796 7.55818 -2.36061e-14 4.64906e-16 -6.45317e-16 +432 1 3.35919 2.51939 7.55818 1.29549e-14 -8.60423e-16 -1.20043e-15 +433 1 5.03879 1.6796 6.71838 0 -5.68989e-16 -2.42861e-15 +434 1 5.87859 2.51939 6.71838 2.20657e-14 -1.10328e-15 -2.7478e-15 +435 1 5.87859 1.6796 7.55818 2.22045e-14 -6.245e-16 5.20417e-16 +436 1 5.03879 2.51939 7.55818 1.38778e-16 -1.83187e-15 -8.46545e-16 +437 1 6.71838 1.6796 6.71838 -2.32453e-15 -5.06539e-16 -2.59515e-15 +438 1 7.55818 2.51939 6.71838 -2.22045e-16 -1.9984e-15 -3.4972e-15 +439 1 7.55818 1.6796 7.55818 6.66134e-16 5.55112e-17 -1.33227e-15 +440 1 6.71838 2.51939 7.55818 -2.83107e-15 -2.06779e-15 -6.66134e-16 +441 1 0 3.35919 6.71838 -1.11022e-14 1.31006e-14 -2.88658e-15 +442 1 0.839798 4.19899 6.71838 2.66454e-15 -2.28359e-14 -4.46865e-15 +443 1 0.839798 3.35919 7.55818 2.55351e-15 1.38362e-14 5.55112e-17 +444 1 0 4.19899 7.55818 -7.99361e-15 -2.44457e-14 -8.88178e-16 +445 1 1.6796 3.35919 6.71838 2.22045e-16 1.20598e-14 -2.05391e-15 +446 1 2.51939 4.19899 6.71838 -1.09635e-15 -2.38767e-14 -4.46171e-15 +447 1 2.51939 3.35919 7.55818 -1.92901e-15 1.40235e-14 -9.02056e-17 +448 1 1.6796 4.19899 7.55818 4.16334e-17 -2.43833e-14 -1.54737e-15 +449 1 3.35919 3.35919 6.71838 1.28716e-14 1.13104e-14 -2.16493e-15 +450 1 4.19899 4.19899 6.71838 -2.44943e-14 -2.37588e-14 -4.78784e-15 +451 1 4.19899 3.35919 7.55818 -2.42584e-14 1.09426e-14 6.38378e-16 +452 1 3.35919 4.19899 7.55818 1.13798e-14 -2.49245e-14 -1.59595e-15 +453 1 5.03879 3.35919 6.71838 -2.35922e-16 8.98587e-15 -1.98452e-15 +454 1 5.87859 4.19899 6.71838 2.29469e-14 -2.33771e-14 -3.1572e-15 +455 1 5.87859 3.35919 7.55818 2.34951e-14 1.07414e-14 1.80411e-15 +456 1 5.03879 4.19899 7.55818 4.16334e-17 -2.19547e-14 -1.42941e-15 +457 1 6.71838 3.35919 6.71838 -3.13638e-15 1.12688e-14 -2.26208e-15 +458 1 7.55818 4.19899 6.71838 2.22045e-16 -2.59792e-14 -1.38778e-15 +459 1 7.55818 3.35919 7.55818 0 1.28855e-14 -8.88178e-16 +460 1 6.71838 4.19899 7.55818 -2.66454e-15 -2.52992e-14 -1.05471e-15 +461 1 0 5.03879 6.71838 -6.21725e-15 2.22045e-16 -2.22045e-15 +462 1 0.839798 5.87859 6.71838 2.55351e-15 2.25375e-14 -2.38698e-15 +463 1 0.839798 5.03879 7.55818 2.66454e-15 1.38778e-17 6.38378e-16 +464 1 0 5.87859 7.55818 -6.21725e-15 2.3842e-14 -2.22045e-16 +465 1 1.6796 5.03879 6.71838 4.44089e-16 -1.17961e-15 -2.20657e-15 +466 1 2.51939 5.87859 6.71838 -1.51962e-15 2.23849e-14 -2.19269e-15 +467 1 2.51939 5.03879 7.55818 -1.90126e-15 -3.26128e-16 6.38378e-16 +468 1 1.6796 5.87859 7.55818 -6.93889e-17 2.2593e-14 1.76942e-15 +469 1 3.35919 5.03879 6.71838 1.02557e-14 -1.31839e-15 -2.20657e-15 +470 1 4.19899 5.87859 6.71838 -2.37102e-14 2.16563e-14 -1.60288e-15 +471 1 4.19899 5.03879 7.55818 -2.25375e-14 1.38778e-17 -7.63278e-16 +472 1 3.35919 5.87859 7.55818 1.15047e-14 2.3162e-14 8.32667e-16 +473 1 5.03879 5.03879 6.71838 -2.28983e-16 -1.00614e-15 -3.27516e-15 +474 1 5.87859 5.87859 6.71838 2.35922e-14 2.19824e-14 -1.88738e-15 +475 1 5.87859 5.03879 7.55818 2.15383e-14 -2.63678e-16 7.70217e-16 +476 1 5.03879 5.87859 7.55818 1.38778e-17 2.13718e-14 3.26128e-16 +477 1 6.71838 5.03879 6.71838 -3.48332e-15 -9.71445e-16 -1.83187e-15 +478 1 7.55818 5.87859 6.71838 -2.22045e-16 2.39808e-14 -3.38618e-15 +479 1 7.55818 5.03879 7.55818 -1.33227e-15 -1.17961e-16 -6.66134e-16 +480 1 6.71838 5.87859 7.55818 -2.83107e-15 2.47372e-14 -3.88578e-16 +481 1 0 6.71838 6.71838 -9.32587e-15 -3.9968e-15 -2.88658e-15 +482 1 0.839798 7.55818 6.71838 2.44249e-15 0 -2.94209e-15 +483 1 0.839798 6.71838 7.55818 2.55351e-15 -3.15026e-15 -3.33067e-16 +484 1 0 7.55818 7.55818 -8.88178e-15 0 -2.22045e-16 +485 1 1.6796 6.71838 6.71838 2.15106e-16 -3.04617e-15 -3.05311e-15 +486 1 2.51939 7.55818 6.71838 -1.54043e-15 -5.55112e-16 -2.72005e-15 +487 1 2.51939 6.71838 7.55818 -2.08167e-15 -2.55351e-15 -2.77556e-17 +488 1 1.6796 7.55818 7.55818 2.77556e-17 -6.66134e-16 -1.11022e-15 +489 1 3.35919 6.71838 6.71838 1.22749e-14 -3.60129e-15 -2.27596e-15 +490 1 4.19899 7.55818 6.71838 -2.57433e-14 -6.66134e-16 -3.27516e-15 +491 1 4.19899 6.71838 7.55818 -2.58682e-14 -3.55271e-15 4.44089e-16 +492 1 3.35919 7.55818 7.55818 1.25316e-14 0 -4.44089e-16 +493 1 5.03879 6.71838 6.71838 0 -4.14252e-15 -3.19189e-15 +494 1 5.87859 7.55818 6.71838 2.47719e-14 -4.996e-16 -2.66454e-15 +495 1 5.87859 6.71838 7.55818 2.47163e-14 -2.66454e-15 -5.55112e-17 +496 1 5.03879 7.55818 7.55818 5.55112e-17 -2.22045e-16 6.66134e-16 +497 1 6.71838 6.71838 6.71838 -2.58127e-15 -3.18495e-15 -3.03924e-15 +498 1 7.55818 7.55818 6.71838 -2.22045e-16 0 -3.05311e-15 +499 1 7.55818 6.71838 7.55818 0 -2.69229e-15 -1.33227e-15 +500 1 6.71838 7.55818 7.55818 -2.66454e-15 9.02056e-16 -2.22045e-16 +ITEM: TIMESTEP +100 +ITEM: NUMBER OF ATOMS +500 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +ITEM: ATOMS id type x y z f_2[1] f_2[2] f_2[3] +1 1 0.123071 8.38872 8.3161 -13.5034 12.7208 4.27264 +2 1 0.832093 0.789482 0.0260634 11.6405 -9.02308 5.27054 +3 1 0.829348 8.32295 0.847054 0.253685 2.42198 0.190462 +4 1 0.167866 0.883683 1.1203 3.78838 -17.5987 -23.5446 +5 1 1.84325 0.268983 0.0506746 -34.1939 -23.1747 -16.5239 +6 1 2.48966 1.02521 0.0150167 17.3336 21.4777 -8.17686 +7 1 2.69085 0.133161 0.584204 54.6376 -37.2919 -8.47938 +8 1 2.03129 0.673907 1.00581 -42.9604 37.8091 32.6152 +9 1 3.4644 0.135395 8.22513 6.66121 1.25052 1.24977 +10 1 4.03955 1.11148 8.14659 12.0412 -8.97859 6.48992 +11 1 4.19379 0.0448744 0.829139 -7.8302 -27.8417 -6.76025 +12 1 3.64841 0.913699 0.700293 -19.72 -1.80986 -1.25088 +13 1 4.95468 8.24864 0.0754237 1.84477 -0.530278 -6.08608 +14 1 5.56087 0.715896 7.89459 8.56765 -1.46102 11.0915 +15 1 5.88623 0.0411411 0.556827 1.26181 -8.5789 -11.0866 +16 1 4.92937 0.724638 0.812217 17.273 10.8714 -8.85433 +17 1 6.72739 8.38085 8.13417 -35.3805 -5.9515 28.6252 +18 1 7.72548 0.788736 0.0488514 2.00593 -21.6326 -29.6842 +19 1 7.72508 8.25409 0.930095 1.50566 4.42937 -3.62071 +20 1 6.80396 0.557293 0.840198 23.1381 -17.3706 0.134541 +21 1 0.229449 1.60533 8.39298 -14.4977 16.7962 1.07689 +22 1 0.832071 2.6454 0.0244343 3.40253 -11.2938 10.3532 +23 1 1.17502 1.54184 1.17348 -25.8959 -2.9461 -24.9151 +24 1 0.259004 2.30396 1.08005 -0.921709 -4.92947 -4.61717 +25 1 1.52612 1.69846 0.0790119 2.24081 -1.66091 4.11232 +26 1 2.32335 2.59169 0.0356063 -1.33192 -7.27448 11.4357 +27 1 2.47613 1.68798 0.866847 -6.11708 -1.09078 12.1273 +28 1 1.75964 2.46963 1.02161 -10.4242 6.62214 -9.26339 +29 1 3.18899 1.91192 0.152422 12.8306 -10.0239 -26.2805 +30 1 4.16606 2.56561 0.31819 6.19268 17.1047 -29.5908 +31 1 4.20679 1.77492 0.904599 6.39419 -20.2587 16.143 +32 1 3.29457 2.54016 0.942536 8.4707 7.62624 9.38928 +33 1 5.08962 1.70142 0.228194 -1.96985 -10.7878 -18.1781 +34 1 5.8401 2.50153 8.17919 2.2116 -4.35098 8.5453 +35 1 6.13077 1.14332 0.361455 -13.4767 12.4455 -5.6398 +36 1 5.21187 2.29543 1.04708 -21.2445 17.0192 -2.44157 +37 1 7.1904 2.12537 8.11861 -26.262 1.63538 -8.89421 +38 1 7.82272 2.3769 0.452291 6.46918 9.92036 10.2415 +39 1 7.65568 1.36632 0.837818 -8.61574 34.9087 15.0511 +40 1 6.63096 2.29607 0.833592 -3.02945 -9.31899 -38.2195 +41 1 0.0701224 3.26957 0.347776 -7.76983 -4.00147 -12.0182 +42 1 0.634247 4.2146 8.13102 5.69069 28.6823 19.9973 +43 1 0.89062 3.25892 1.01274 -8.90571 5.17288 9.1951 +44 1 8.35578 4.21333 0.756755 0.0651816 10.3427 6.16366 +45 1 1.59376 3.50824 0.337522 12.8481 -18.5931 -31.178 +46 1 2.63362 4.08805 -0.0117409 -13.6881 -31.4545 31.8377 +47 1 2.64545 3.44217 0.972182 1.32962 4.76915 -6.91838 +48 1 1.77157 4.31331 0.893182 6.24463 15.8362 30.2465 +49 1 3.30506 3.15734 -0.00281637 -4.50664 8.90697 10.0795 +50 1 4.20121 3.98351 8.24532 14.9588 -4.89636 4.16185 +51 1 4.14049 3.34001 1.03567 7.31744 -35.2634 -0.734077 +52 1 3.55633 4.09497 0.714486 -22.5487 2.59697 3.44603 +53 1 5.00488 3.2958 8.40544 4.72004 -3.7586 -0.0676635 +54 1 6.02419 4.38739 8.28472 2.63675 -3.85348 -7.36203 +55 1 5.82125 3.13701 0.812331 3.285 1.60137 -0.83853 +56 1 4.81191 4.1205 0.886429 26.0514 -19.7571 -10.6482 +57 1 6.37904 3.38462 8.29958 8.77859 5.40588 1.21659 +58 1 7.16155 4.27433 8.23885 -4.15514 -15.8519 20.8515 +59 1 7.46381 3.5222 0.62725 -6.50801 1.62892 11.1525 +60 1 6.52496 4.16064 0.796816 7.21171 -6.93074 -7.48151 +61 1 8.21062 5.02405 8.32529 2.06274 -1.43255 -7.09188 +62 1 0.856242 5.68027 8.15143 -7.33544 -9.25849 21.6195 +63 1 0.668812 5.05722 1.0253 10.4106 -11.6037 -16.0599 +64 1 0.100757 5.9519 0.987463 -8.02818 6.7945 -7.41084 +65 1 1.67634 4.74298 8.35528 -7.26839 1.52359 -11.0387 +66 1 2.38848 5.51086 0.107164 2.54651 6.03927 1.46743 +67 1 2.70757 4.93813 1.01132 -4.75577 -9.71554 1.13089 +68 1 1.3925 5.83052 0.707681 -1.14437 -6.44566 7.34655 +69 1 3.45574 4.66587 8.23291 4.73605 39.4767 5.5614 +70 1 4.43743 5.80479 0.164115 -6.64024 0.386075 1.78009 +71 1 4.2065 4.90669 0.741814 -23.5797 23.1046 -22.8102 +72 1 3.32112 5.74269 0.715517 7.3169 4.77905 3.84994 +73 1 5.16076 4.9557 8.31038 -10.6163 5.08193 1.86037 +74 1 5.94307 5.96922 0.174598 0.307423 -9.87615 -0.075099 +75 1 5.67998 4.99641 0.866467 -3.37502 0.387608 -1.06988 +76 1 5.10533 6.15466 0.974945 -0.684733 -17.9465 -18.2172 +77 1 6.66954 5.212 0.215572 3.55269 -19.7927 -9.30717 +78 1 7.63194 6.03007 0.0625005 22.452 -11.4487 -13.3981 +79 1 7.77987 5.15692 0.880268 -13.4303 3.64316 1.97115 +80 1 6.9443 6.00859 0.774386 -22.1564 -21.0173 44.3085 +81 1 0.211543 6.60981 0.114883 -6.22763 -3.96979 4.85396 +82 1 0.828363 7.71074 8.05758 6.57912 -12.175 1.18202 +83 1 0.8511 6.85772 1.00145 14.3344 -16.9148 6.86093 +84 1 0.108182 7.491 0.729711 -16.3275 13.3125 -2.16192 +85 1 1.32651 6.53754 8.31267 17.3977 32.295 0.779922 +86 1 2.45313 7.32438 0.161863 4.38219 8.94585 -15.0057 +87 1 2.22206 6.5101 0.817864 2.61276 2.64125 -0.96007 +88 1 1.71157 7.54558 0.836721 -10.8648 3.37169 8.49449 +89 1 3.33137 6.74361 0.251121 4.01956 -5.07144 -3.19134 +90 1 4.31785 7.3164 0.250439 -2.62105 14.0423 -19.3334 +91 1 4.11403 6.69271 1.01148 -3.23605 5.58393 9.21791 +92 1 3.25046 7.65301 0.863299 7.69366 -3.67127 3.31805 +93 1 5.15822 6.61638 8.39412 -15.5898 18.5262 -4.77657 +94 1 5.88176 7.47131 8.35911 1.25772 40.9097 -41.218 +95 1 5.8589 6.89406 0.716878 17.4729 -36.9167 60.1945 +96 1 5.1317 7.5805 0.887324 -15.4398 8.72154 0.622041 +97 1 6.7242 6.72984 0.126171 2.95649 13.978 -28.6002 +98 1 7.71076 7.70275 8.27387 -25.252 1.96163 47.723 +99 1 7.67756 6.66145 0.969756 13.165 19.6736 4.48693 +100 1 6.86126 7.61056 0.694229 -2.98636 3.99324 3.02821 +101 1 8.36607 8.27958 1.86716 -0.17632 -3.19355 -10.789 +102 1 0.956051 0.693329 1.82901 -1.1092 0.489919 9.03263 +103 1 0.677954 8.19357 2.69404 9.64796 -1.44576 4.92708 +104 1 8.40822 0.658358 2.57043 0.358989 35.1247 -30.1625 +105 1 1.59709 8.27384 1.6579 -3.48424 8.95256 3.83776 +106 1 2.60262 0.937274 1.91114 -6.85695 -44.4167 -8.16487 +107 1 2.77964 8.33738 2.42411 -9.97653 17.8509 12.2111 +108 1 1.80103 0.545423 2.70436 3.05773 -0.374817 -3.43865 +109 1 3.48439 0.0645578 1.59153 -12.2456 1.16104 1.511 +110 1 4.22306 0.908637 1.62246 8.21176 3.032 -1.28199 +111 1 4.10829 0.251535 2.42791 -11.6297 -7.60593 -5.50766 +112 1 3.3006 0.854758 2.76304 -19.992 -17.3193 -31.4497 +113 1 4.89013 8.37666 1.691 47.9119 57.0599 0.585594 +114 1 5.94061 0.477826 1.48406 -3.07899 1.88699 12.3275 +115 1 5.88048 0.35971 2.56281 -4.35157 -20.3865 4.17854 +116 1 4.9283 1.00358 2.55425 0.721177 -5.70224 -8.52683 +117 1 6.83323 8.16485 1.66012 -9.63203 10.6138 -6.53177 +118 1 7.60236 0.72315 1.6205 1.19764 -13.0731 15.2148 +119 1 7.46261 8.34785 2.50942 4.27014 7.86644 3.21827 +120 1 6.98477 1.01167 2.43863 -2.7077 -3.72405 10.5475 +121 1 0.201795 1.49879 1.91201 12.0746 15.4759 7.55997 +122 1 0.970651 2.5763 1.77546 9.10281 -9.21672 19.206 +123 1 1.00278 1.70354 2.64935 -4.86832 -2.32063 -12.0578 +124 1 0.220174 2.4694 2.59226 -6.06395 2.41662 -4.31274 +125 1 1.87438 1.66139 1.85364 0.0891009 8.26815 7.54904 +126 1 2.5634 2.61259 1.66324 -1.39613 -9.56029 15.7565 +127 1 2.67373 1.74855 2.48368 16.2507 26.3662 25.5413 +128 1 1.81271 2.51993 2.48462 -12.4635 -12.9481 6.24626 +129 1 3.34642 1.5174 1.55361 6.72778 19.0825 -4.097 +130 1 4.08393 2.3973 1.7811 -4.91883 6.9472 -7.45962 +131 1 3.95017 1.57032 2.47783 9.96822 8.42852 -4.63348 +132 1 3.54843 2.54548 2.73936 0.891724 -11.4891 -8.75214 +133 1 5.35058 1.38537 1.51823 -3.50731 -2.89085 5.66595 +134 1 6.023 2.29204 1.65213 -4.43652 -0.464129 22.1024 +135 1 5.94747 1.35093 2.39209 2.54676 22.9646 2.61125 +136 1 4.92685 2.18916 2.37644 10.4243 -2.12633 1.01963 +137 1 6.61187 1.36453 1.49274 0.221959 8.29598 -0.620687 +138 1 7.32473 2.28685 1.57865 28.4734 -28.9459 -8.73783 +139 1 7.72873 1.81047 2.35176 -1.00775 -9.06934 31.0045 +140 1 6.61584 2.21437 2.52479 7.01251 0.0677084 2.80218 +141 1 8.39022 3.27891 1.73012 3.49525 -5.17929 -4.65996 +142 1 0.854964 4.19407 1.69788 1.56946 -2.00702 1.06174 +143 1 0.997978 3.23715 2.67504 2.30643 5.8223 1.06858 +144 1 7.97382 3.9138 2.48815 10.0732 9.91828 -12.5132 +145 1 1.83784 3.47408 1.69517 -12.404 -3.21409 -2.66267 +146 1 2.61842 4.21682 1.90008 2.14748 0.059531 -3.785 +147 1 2.48603 3.26502 2.5249 16.8304 14.9965 0.171158 +148 1 1.68761 4.23907 2.52806 -1.01396 -4.72261 -0.795752 +149 1 3.40602 3.2813 1.85914 -16.1626 0.355927 -8.83409 +150 1 4.09906 4.10307 1.70079 5.35563 8.08157 -4.08084 +151 1 4.20252 3.30769 2.50236 16.5461 8.94662 0.427258 +152 1 3.52577 4.20363 2.52362 -12.9682 0.481811 23.6133 +153 1 5.11847 3.18122 1.75203 -10.5302 -5.4337 -0.263304 +154 1 5.84661 3.9209 1.56262 -0.517958 8.86577 8.63788 +155 1 5.86922 3.05768 2.56393 3.07392 -0.105811 -3.05554 +156 1 4.80787 4.20147 2.51562 -15.5306 -18.6016 6.98719 +157 1 6.75594 3.06184 1.51831 -23.9843 53.9056 5.35996 +158 1 7.37411 4.33015 1.50837 10.7935 -8.89263 2.38858 +159 1 7.49772 2.90887 2.46868 -6.63254 10.1343 -14.9923 +160 1 6.70853 3.86113 2.32478 1.28299 1.19192 -0.76331 +161 1 8.35107 4.97447 1.76826 -6.01727 -4.60108 12.0065 +162 1 0.812206 5.83167 1.72433 7.83055 6.4827 17.8655 +163 1 0.780537 4.91988 2.60048 6.34607 -5.57446 -13.8552 +164 1 8.22728 5.818 2.44166 16.0462 -1.57715 15.6299 +165 1 1.69572 5.11642 1.80574 -4.96566 -14.135 -5.31489 +166 1 2.43043 5.85297 1.63568 5.29915 -1.62077 5.85546 +167 1 2.57792 5.02783 2.65315 -4.52746 -19.2236 -8.91777 +168 1 1.53526 5.79854 2.60003 3.8059 -10.2938 -9.84612 +169 1 3.51815 5.02648 1.76532 -11.6984 -21.692 -35.1665 +170 1 4.20879 5.78771 1.44267 -4.45704 -9.43328 11.2812 +171 1 4.17986 5.08228 2.52246 26.037 -4.72131 -0.0794421 +172 1 3.28564 5.71935 2.4374 15.7539 34.931 2.27384 +173 1 4.77269 4.90482 1.56605 20.4715 8.53759 27.1606 +174 1 6.0822 5.98003 1.39493 -10.1112 -7.66907 2.17662 +175 1 5.55864 4.81486 2.32198 32.4427 -4.71792 -40.0608 +176 1 5.42317 5.8389 2.32907 -1.32862 11.7729 0.869635 +177 1 6.58632 5.00994 1.4228 1.50987 11.9718 7.91199 +178 1 7.40728 5.76017 1.85143 -17.7756 -1.69935 -20.7445 +179 1 7.43483 4.90248 2.50406 4.81208 -4.17509 -3.00519 +180 1 6.49032 6.25339 2.53785 -9.86939 -13.1275 -11.226 +181 1 8.38687 6.70803 1.84686 8.51598 2.67685 -7.76441 +182 1 0.82672 7.5809 1.8586 -8.65199 -8.55201 -6.88257 +183 1 0.798368 6.66179 2.58415 -9.89719 -0.151349 -9.60426 +184 1 8.09266 7.50342 2.71078 14.8523 -0.33865 -5.72558 +185 1 1.67226 6.92941 1.90638 3.68667 -6.81729 -3.8166 +186 1 2.44977 7.72472 1.67328 13.6121 -19.3583 -10.8323 +187 1 2.6005 7.00136 2.53195 -4.75836 -8.709 1.95523 +188 1 1.74762 7.69197 2.71318 -2.53247 4.05033 -0.19863 +189 1 3.12318 6.68472 1.56494 -10.4586 3.85751 -11.4518 +190 1 4.29009 7.65387 1.60791 -51.7416 -54.1223 -14.9832 +191 1 3.94907 6.70085 2.16915 18.0446 -8.10905 7.08373 +192 1 3.47208 7.58339 2.49347 14.5465 5.92984 -2.02778 +193 1 5.12563 6.77282 1.76131 -9.48863 14.4825 6.97263 +194 1 5.83539 7.62987 1.64588 8.72191 3.82062 7.16953 +195 1 5.76423 6.96836 2.55864 -5.64345 11.6948 11.2338 +196 1 4.77822 7.71547 2.51809 6.21883 -11.3323 9.13654 +197 1 6.63559 6.81418 1.65333 9.11964 14.1494 -8.37133 +198 1 7.61434 7.47455 1.72558 2.40335 0.461228 -6.0911 +199 1 7.4792 6.66861 2.39873 -2.80551 0.930229 8.6336 +200 1 6.74988 7.49855 2.51532 0.27108 -2.11137 5.23264 +201 1 8.33028 0.11458 3.36279 -16.5826 -29.3888 39.8482 +202 1 0.924222 0.663074 3.34599 -4.22349 8.71948 1.26084 +203 1 0.761543 8.18959 3.97906 2.12091 4.50677 4.24971 +204 1 8.33433 0.813163 4.20564 6.5007 1.52148 -0.192127 +205 1 1.76574 0.0375621 3.77071 17.3013 -16.3871 -16.9245 +206 1 2.61977 0.818953 3.52119 -23.2651 -2.55324 12.2346 +207 1 2.77562 0.0652161 4.44741 -11.8421 6.13727 -13.8855 +208 1 1.49199 0.761034 4.41597 -5.10709 15.0925 14.5126 +209 1 3.2179 8.34804 3.44668 5.27936 -7.50847 -1.90568 +210 1 3.9439 0.797129 3.52456 17.3728 2.18733 11.5361 +211 1 4.23279 0.116688 4.32559 -2.42219 -2.56552 -2.26636 +212 1 3.32804 0.997948 4.36883 1.65433 -5.54648 3.47818 +213 1 4.71275 0.120112 3.21294 23.362 4.56383 23.3458 +214 1 5.81093 1.04185 3.50642 -3.03834 -26.4106 -17.8435 +215 1 5.68877 0.288558 4.20831 -1.41276 -13.7346 9.5471 +216 1 5.01865 1.1392 4.32627 0.968145 -3.23051 -6.43149 +217 1 6.64793 8.39618 3.24984 2.09632 -4.36032 3.69009 +218 1 7.5883 0.965027 3.40354 -4.44096 -3.20185 -1.58139 +219 1 7.46506 8.38162 4.26807 1.21074 2.40143 -20.8016 +220 1 6.68567 0.729309 4.05423 9.00491 -0.0257829 7.04417 +221 1 0.0217051 1.65067 3.33296 -0.896942 -12.0422 -1.44038 +222 1 0.778955 2.33585 3.53158 8.17696 34.6193 -17.2054 +223 1 0.812105 1.63712 4.22741 2.15493 -21.1842 9.58449 +224 1 8.36402 2.71734 4.23224 9.90405 -0.180735 2.89262 +225 1 1.64503 1.55583 3.44456 9.91651 -2.24847 10.5707 +226 1 2.72789 2.60115 3.33289 -22.1633 -6.4618 14.3253 +227 1 2.53285 1.75288 4.15927 -11.2604 4.59027 8.59695 +228 1 1.59486 2.51559 4.29587 -0.634079 -19.903 20.3392 +229 1 3.26158 1.6458 3.43181 16.9482 17.4067 -1.31054 +230 1 4.49124 2.67296 3.29881 0.516577 8.93567 6.85853 +231 1 4.12441 1.76399 4.16025 -12.4119 -16.9863 20.8263 +232 1 3.58648 2.62356 4.12513 -11.0948 -0.0880381 2.09248 +233 1 4.62064 1.66433 3.30411 17.3359 -14.3916 -7.7698 +234 1 5.72203 2.02067 3.4449 -2.49843 31.6335 -13.0426 +235 1 6.15135 1.60495 4.33133 -9.75959 4.02084 8.19224 +236 1 5.04088 2.23941 4.27882 30.2001 -2.39587 -19.7025 +237 1 6.91779 1.8813 3.52264 3.96777 -26.054 4.41687 +238 1 7.81771 2.53776 3.353 -2.77684 -3.41763 12.6677 +239 1 7.78069 1.81171 4.34601 -52.3825 1.07947 -51.791 +240 1 6.66141 2.49312 4.62997 -6.69802 -0.0628228 -12.7191 +241 1 0.122629 3.46604 3.3479 -1.26446 -22.7991 -11.2332 +242 1 0.85888 4.22824 3.46647 2.79502 3.87933 -3.60293 +243 1 0.937247 3.40088 4.29114 -12.1658 -1.27655 -7.25993 +244 1 8.30307 4.19021 4.02192 -7.37977 10.0618 19.4199 +245 1 1.73804 3.18337 3.5685 -15.8464 9.26468 -37.1326 +246 1 2.58615 4.05913 3.19953 0.360202 14.7294 -1.16411 +247 1 2.55925 3.4674 4.05471 16.7959 -2.51521 13.6147 +248 1 1.75131 4.20697 4.04231 3.51698 -5.56503 7.27084 +249 1 3.44857 3.37138 3.44602 9.39764 18.3315 -14.5187 +250 1 4.30487 4.37452 3.51867 -0.743412 -11.0963 -4.3924 +251 1 4.41614 3.34547 4.13696 17.6233 7.57534 -14.2893 +252 1 3.32801 4.25542 4.08286 6.07649 -1.13934 3.22429 +253 1 5.63651 3.09553 3.631 -4.7187 3.44811 6.48572 +254 1 5.99275 4.08946 3.17209 -2.06613 -3.23888 -8.73239 +255 1 6.47603 3.67609 4.18744 -9.24013 0.891239 -0.0265923 +256 1 5.32989 4.17403 4.01248 -3.14576 -0.648453 6.26049 +257 1 6.72457 2.86539 3.51605 -3.69406 17.3565 -4.96963 +258 1 7.32281 3.76777 3.25105 -10.2265 -1.63605 18.2335 +259 1 7.4303 3.25631 4.3358 5.44768 7.87627 -9.74689 +260 1 6.66407 4.65396 3.76405 -6.96361 -4.18223 2.73914 +261 1 8.26711 4.8857 3.17584 6.51218 -0.295316 -2.27808 +262 1 0.649285 5.74933 3.20979 -12.9544 -9.12523 -13.313 +263 1 1.01858 5.10915 4.40565 1.04387 0.402418 -2.70019 +264 1 0.0855082 5.80312 4.16158 -11.0199 -7.09759 8.81305 +265 1 1.78399 4.97143 3.32025 -23.7199 7.54456 -3.60592 +266 1 2.55969 5.96317 3.12483 -8.84523 11.7944 16.8138 +267 1 2.653 5.05017 3.85074 -4.37713 4.79953 16.9312 +268 1 2.04667 5.9581 4.23583 -12.9689 -9.50066 -2.67062 +269 1 3.52568 5.09169 3.32195 -1.60301 -3.74832 -0.530875 +270 1 4.17719 5.92991 3.13207 5.79449 2.84869 4.98978 +271 1 4.69237 5.20087 4.04914 -22.9168 0.480558 19.5714 +272 1 3.49623 5.87284 4.08872 -22.1914 -19.7939 -11.835 +273 1 5.22134 4.9979 3.22696 -11.435 -2.89555 -13.2152 +274 1 5.65705 6.11892 3.42751 2.78011 1.11701 -3.25891 +275 1 5.76121 5.22134 4.03501 7.67556 -2.59727 25.3068 +276 1 4.95772 6.04539 4.58052 58.0203 8.0254 -45.1554 +277 1 6.4538 5.11955 2.78748 -4.74406 7.07146 5.73728 +278 1 7.21538 5.95413 3.16364 10.7768 -10.9442 6.36207 +279 1 7.51809 5.20099 3.85697 17.9797 5.14787 9.68311 +280 1 6.63903 5.76912 4.06379 2.12496 12.0521 4.75162 +281 1 8.12324 6.45888 3.3557 6.09728 0.195353 -8.64393 +282 1 0.462088 7.19726 3.46792 19.553 -0.0547515 -15.4409 +283 1 0.957118 6.33073 3.94731 10.4711 20.6934 10.8557 +284 1 8.31788 7.62476 4.18946 -15.5996 1.5203 27.0435 +285 1 1.621 6.60508 3.20723 21.3874 20.2704 9.57573 +286 1 2.43565 7.40381 3.575 -2.23423 10.7661 -7.60718 +287 1 2.75508 6.70843 4.26783 9.69215 -9.86312 8.63304 +288 1 1.4194 7.32943 4.0782 6.712 1.12768 -13.3449 +289 1 3.55435 6.77984 3.25216 -11.0849 -3.43265 4.44657 +290 1 4.09983 7.6717 3.40332 0.775894 2.91256 6.51607 +291 1 4.08342 6.6168 4.34423 8.99422 27.9061 4.38721 +292 1 3.36001 7.55781 4.25663 44.0502 4.81661 -43.4399 +293 1 4.74991 6.77738 3.51304 4.59094 -3.55683 -10.177 +294 1 5.77556 7.6737 3.71378 -0.245399 -1.3978 -0.93703 +295 1 5.90589 6.74801 4.34426 -3.316 -4.25196 -0.216303 +296 1 4.8074 7.40991 4.34207 4.23627 19.8452 -2.32284 +297 1 6.58813 6.85169 3.45364 -7.67639 -5.27403 -11.3349 +298 1 7.50241 7.47925 3.56723 2.18816 13.5038 -24.0989 +299 1 7.40344 6.62065 4.10638 -2.8935 -4.19323 5.51308 +300 1 6.75843 7.5046 4.25149 -20.47 8.43665 16.7865 +301 1 8.33167 8.36145 4.9892 0.225809 34.2346 -31.8957 +302 1 0.576342 0.867151 5.40959 24.5697 -12.6304 -33.2572 +303 1 0.763006 0.00458111 6.00676 12.4506 6.43147 -2.11226 +304 1 8.26499 0.860176 6.08382 -7.17683 -4.07129 -51.5552 +305 1 1.81244 8.0383 4.87052 -5.76863 7.26347 -9.86755 +306 1 2.53533 1.09902 5.19234 -3.16803 0.678291 -2.97003 +307 1 2.78135 0.403413 6.40689 -26.816 9.12488 -11.3363 +308 1 1.58905 0.651353 5.66283 7.03419 0.981612 1.76622 +309 1 3.32058 0.106866 5.32447 -0.932856 13.5857 14.9154 +310 1 4.27557 0.92435 5.10725 -6.99093 5.63655 -6.45098 +311 1 4.28959 0.280237 5.95961 -30.2191 -30.0316 -14.6333 +312 1 3.38904 1.26869 5.835 20.8336 -7.28254 -13.6106 +313 1 5.00946 8.32617 5.09801 -7.438 6.03549 0.926349 +314 1 5.92216 0.863628 5.14574 -0.277075 -6.34381 -3.05305 +315 1 5.73427 0.0193827 5.90902 4.17974 0.428592 2.11829 +316 1 4.94752 0.963499 5.95092 36.9682 12.4342 8.28196 +317 1 6.68007 0.0753806 5.17719 -6.21888 -0.275929 -7.94036 +318 1 7.59475 0.718477 4.99 5.56935 4.26124 12.8688 +319 1 7.48253 8.3166 5.84711 10.9136 10.2783 15.4989 +320 1 6.8326 0.897437 5.9487 8.18452 -13.9005 5.8213 +321 1 0.0760609 1.64664 4.96296 26.1716 -2.70613 34.3225 +322 1 0.685552 2.56455 5.03633 12.0035 4.84556 -15.2829 +323 1 0.606729 1.82267 5.82598 7.27963 -3.46786 12.0617 +324 1 8.3293 2.58271 5.72712 2.9601 13.0212 32.1025 +325 1 1.39999 1.70565 5.12122 8.3487 -4.09076 2.04128 +326 1 2.73507 2.85653 4.90403 -0.345779 -0.804973 -4.73226 +327 1 2.41817 2.24309 5.70209 1.42091 -4.90412 -0.964796 +328 1 1.38108 2.54746 5.86585 12.2906 4.17611 0.525771 +329 1 3.33731 1.91289 4.90293 0.0185627 0.794978 8.4213 +330 1 4.3973 2.60866 4.92615 -15.1153 4.67891 22.5372 +331 1 4.2225 2.0218 5.81106 18.0418 -47.4422 -19.4137 +332 1 3.4994 2.65878 5.66207 -24.6152 28.1329 2.91513 +333 1 5.20081 1.64695 5.25699 -1.61968 25.0354 -10.6249 +334 1 5.90254 2.56674 5.38347 4.70787 3.18361 -12.95 +335 1 6.08989 1.61464 5.89214 -10.9271 -1.55847 2.77666 +336 1 5.02754 2.69198 5.87273 -13.869 2.1523 1.52243 +337 1 6.90208 1.46146 5.07178 -10.118 15.4867 -8.4201 +338 1 7.58477 2.54489 5.07036 0.223295 2.60985 -3.71518 +339 1 7.69807 1.70404 5.74305 2.65747 -7.01835 5.70621 +340 1 6.83671 2.31874 5.77518 8.75763 5.85965 2.81961 +341 1 8.33535 3.4475 5.0472 4.04483 5.65066 -3.26522 +342 1 0.908217 4.16423 5.06292 -2.0575 1.13184 -0.501506 +343 1 0.771491 3.42595 5.87741 5.33449 1.31478 -10.6197 +344 1 0.14652 4.33584 6.04676 1.00462 -8.1578 -20.2597 +345 1 1.77294 3.51463 4.93957 -1.27898 -7.63546 3.32247 +346 1 2.71396 3.96357 4.97834 15.9141 3.79204 10.1307 +347 1 2.46159 3.38803 6.16546 -1.0491 -20.8555 -15.9327 +348 1 1.72608 4.39112 6.04032 -15.046 -11.018 -10.0045 +349 1 3.71274 3.40467 4.85974 -22.3519 13.9348 10.8973 +350 1 4.57553 4.21697 4.87404 -3.96399 7.00234 -1.98713 +351 1 4.366 3.53193 5.70269 7.89254 -3.17347 6.37497 +352 1 3.55123 4.20329 5.82208 -22.8323 -11.992 0.86056 +353 1 5.31479 3.43328 4.96004 -12.842 -18.3451 -4.95866 +354 1 5.96487 4.21664 4.98586 3.26728 12.2832 1.14917 +355 1 5.67633 3.58987 5.96581 6.91479 -13.8012 -0.0730494 +356 1 5.15168 4.48521 5.88819 -0.135174 -6.62981 7.61527 +357 1 6.76571 3.37692 5.24691 -14.8051 -2.47074 -4.50431 +358 1 7.42413 4.19524 5.01259 2.27671 4.46784 -0.576517 +359 1 7.6092 3.42318 5.84837 11.8264 -15.8262 -18.7291 +360 1 6.54398 4.29611 5.89957 10.509 -8.9195 -1.16059 +361 1 0.0247094 4.83566 4.99938 1.36656 0.603431 -2.15766 +362 1 0.966205 6.14847 4.9405 -1.84638 -2.56131 10.6129 +363 1 1.10739 5.11215 5.5368 -2.77114 7.32267 -6.17701 +364 1 0.221311 5.77966 5.62316 -16.3542 -5.99991 -34.5248 +365 1 2.09075 4.80339 4.88071 -15.5377 1.88455 -3.51044 +366 1 2.76626 5.59872 5.00497 -13.1053 -0.333159 -40.3797 +367 1 2.60002 4.95633 5.81939 -13.3057 -3.60712 -16.1699 +368 1 1.73302 6.11974 5.67311 7.80367 -13.5214 9.39307 +369 1 3.69174 5.11983 4.8182 4.27828 -13.6521 -3.16237 +370 1 4.24517 5.95869 5.19837 -53.2876 -10.1225 40.5156 +371 1 4.22774 4.94663 5.7496 8.19104 22.5118 -1.663 +372 1 3.1136 6.02947 5.80151 37.6339 -12.4217 36.265 +373 1 5.23537 5.12533 5.07481 2.14794 5.35663 -5.58383 +374 1 5.80775 6.19434 5.36474 -12.1517 -18.4331 -19.8184 +375 1 5.9697 5.18437 6.0003 -7.47906 6.99384 0.912527 +376 1 4.94854 5.8692 5.99559 17.5377 -1.26338 -12.9619 +377 1 6.59757 5.09144 5.08104 3.06742 4.08464 -2.92894 +378 1 7.54367 5.98613 4.88573 -14.2361 -23.7654 7.79426 +379 1 7.60847 5.23322 5.63185 -1.35187 -6.94343 4.2911 +380 1 6.70769 5.94816 5.81677 14.1283 2.13907 3.81564 +381 1 8.22278 6.71702 5.01662 22.4316 17.1972 -3.51396 +382 1 0.869349 7.28869 4.96667 -10.0366 3.62496 3.89926 +383 1 0.896793 6.73687 5.91431 -6.40765 3.74255 3.0528 +384 1 0.0890555 7.7054 5.6706 -5.18167 -47.9244 34.8448 +385 1 1.8751 6.88564 4.94229 0.477268 -2.00274 -5.71819 +386 1 2.7587 7.55291 4.99872 -36.0591 6.05211 43.0833 +387 1 2.53846 6.82983 5.7787 -13.9577 26.1772 12.6196 +388 1 1.63934 7.57104 5.79621 -1.51722 -4.07644 10.4552 +389 1 3.46612 6.83867 5.20388 -3.25728 -8.15264 -25.1259 +390 1 4.01792 7.77747 5.13143 8.22604 -9.98488 -11.0207 +391 1 4.0616 6.71165 5.99374 37.4635 -34.7522 2.57336 +392 1 3.49035 7.48383 6.06615 -52.3442 43.3465 -6.60384 +393 1 4.82693 6.8523 5.20763 2.69445 10.0085 20.3981 +394 1 5.83663 7.67662 4.94011 2.65651 0.782445 -0.458959 +395 1 5.60118 6.903 6.05259 0.51238 5.45548 -5.22943 +396 1 4.49984 7.67391 6.05154 31.0401 -0.647522 -9.371 +397 1 6.56806 6.92617 5.22736 4.49918 -20.7724 -24.6194 +398 1 7.45007 7.68748 5.02454 6.13987 -21.0163 7.77973 +399 1 7.49751 6.80367 5.78308 -9.98894 13.1501 -5.7166 +400 1 6.63057 7.61754 5.92417 0.0687578 21.3795 23.8905 +401 1 8.32557 8.34894 6.68981 0.104638 -13.8897 -9.6087 +402 1 0.744366 0.980723 6.48852 -5.23114 -31.7269 30.0044 +403 1 1.21108 0.262565 7.55604 -5.48851 -4.18087 -6.76609 +404 1 8.40118 0.701811 7.40569 17.4537 3.62996 11.6339 +405 1 1.79336 8.32699 6.64062 -5.93242 0.737609 -0.84307 +406 1 2.60519 1.4776 6.42908 -42.7477 -20.3947 10.8513 +407 1 2.68468 8.32969 7.50367 2.82039 -8.74718 0.911275 +408 1 2.14004 0.776947 7.26895 -3.65906 16.1309 -1.11008 +409 1 3.6569 0.0715803 6.70451 13.9675 -20.3473 29.1568 +410 1 3.94985 1.1248 6.78323 8.0083 0.919865 -1.94163 +411 1 4.44955 0.15543 7.5921 -15.5929 3.09145 7.2634 +412 1 3.18676 1.19789 7.55079 30.4701 -36.3009 -8.08868 +413 1 5.10396 0.131358 6.81912 -7.97923 37.9971 -21.1894 +414 1 5.81993 0.996314 6.79068 7.76858 -21.7284 -2.73997 +415 1 5.80025 8.18188 7.49322 12.3507 -13.1302 8.70784 +416 1 4.85408 1.28227 7.42764 -12.4579 -6.47968 -9.5274 +417 1 6.58875 0.130914 6.74241 2.12753 -2.2097 0.634037 +418 1 7.59964 0.676617 6.71682 -68.3673 2.07925 42.2066 +419 1 7.52212 0.0593286 7.5834 32.5631 3.04014 -28.8024 +420 1 6.85279 0.923554 7.57208 -4.28539 1.49265 -2.17621 +421 1 8.34941 1.72633 6.6429 -6.24486 10.7883 12.2426 +422 1 0.752277 2.47155 6.72526 -3.9412 -10.7788 3.00465 +423 1 0.813192 1.63555 7.42993 -7.74314 -11.2011 -0.638694 +424 1 8.22443 2.54813 7.66732 2.56273 -1.56785 0.82339 +425 1 1.49636 1.56107 6.38447 44.5625 33.4582 -3.13704 +426 1 2.30525 2.475 6.76961 -5.35408 6.54562 -0.949005 +427 1 2.49056 1.84724 7.59513 -61.407 9.30511 10.8314 +428 1 1.49273 2.39823 7.65033 13.5773 11.0727 -11.0854 +429 1 3.37689 2.03992 6.64219 17.5424 18.1797 1.52712 +430 1 4.36556 2.35363 6.72974 2.65202 20.8248 17.9478 +431 1 3.99822 2.02063 7.6547 18.3091 -10.0739 6.1027 +432 1 3.17328 2.55424 7.53823 -10.8617 31.8229 -4.73645 +433 1 5.21112 1.76508 6.50479 -18.4173 6.52495 3.64931 +434 1 5.87572 2.50861 6.47972 17.6588 16.4017 11.3405 +435 1 6.13161 1.75643 7.42519 -6.35346 6.11936 8.80778 +436 1 5.08243 2.27965 7.49559 3.10695 14.763 0.591819 +437 1 6.90515 1.73737 6.69685 6.36969 -4.89015 -2.67266 +438 1 7.59965 2.63279 6.71489 9.55617 -0.301288 -8.47778 +439 1 7.76189 1.52013 7.52701 3.93719 -1.66085 -6.19761 +440 1 6.70724 2.6779 7.2598 -8.99322 4.2321 11.9078 +441 1 0.125444 3.31521 6.66881 -20.5423 -11.9528 1.08126 +442 1 0.364694 4.22273 7.06 15.4688 8.78987 -5.27721 +443 1 0.60791 3.34758 7.65433 9.81501 -30.9601 -14.2913 +444 1 8.0984 3.85412 7.73406 0.295867 21.4592 0.238003 +445 1 1.38869 3.28611 6.86269 8.50148 8.2104 -0.813622 +446 1 2.52476 4.25334 6.66316 13.9982 13.4488 20.9739 +447 1 2.34408 3.26799 7.64808 -1.14502 9.26403 -10.1755 +448 1 1.45935 4.43411 7.31503 0.0272838 -0.538431 -2.52173 +449 1 3.66593 3.34626 6.65797 -1.50742 -4.19973 -15.7128 +450 1 4.32339 4.28741 6.63848 -1.71153 0.00989822 -0.270268 +451 1 4.03917 3.1404 7.61252 24.7136 -10.2891 3.12208 +452 1 3.36907 3.93473 7.50701 -10.481 -0.383957 -6.9951 +453 1 4.88527 3.3354 6.73465 -0.250758 1.18323 3.20962 +454 1 5.86197 4.30684 6.74144 -6.02175 10.4775 -12.9313 +455 1 5.83143 3.4729 7.33725 -5.24712 -23.3614 7.27214 +456 1 5.04517 4.19893 7.47372 14.0277 -13.7659 1.86079 +457 1 6.67093 3.19494 6.32389 -1.08882 16.2366 5.3564 +458 1 7.58567 3.93824 6.68879 13.8607 17.9546 17.9945 +459 1 7.41034 3.22296 8.01852 -22.7502 -28.7124 0.282368 +460 1 6.74041 3.98357 7.25541 -1.38378 3.03134 11.4432 +461 1 8.11164 5.05821 6.64701 -10.3621 4.23498 3.48281 +462 1 0.434229 5.95598 6.55583 13.6324 -1.56553 39.6492 +463 1 0.429061 5.17903 7.41995 -0.29478 -7.71855 -15.5486 +464 1 8.09598 5.94892 7.38464 -0.670206 -2.17368 6.38869 +465 1 1.41611 5.29567 6.55129 0.191903 6.07763 6.12613 +466 1 2.44376 5.87825 6.63669 -4.18767 0.226771 1.1996 +467 1 2.57445 4.71437 7.62895 -9.06207 26.6712 -23.195 +468 1 1.76163 5.67875 7.56712 4.16416 -0.382203 -1.94173 +469 1 3.23562 5.1121 6.55719 20.8924 -0.347412 22.4145 +470 1 4.05367 5.80831 6.49809 -13.6658 -13.8236 9.34588 +471 1 4.3499 4.91428 7.57309 -17.8958 19.2373 1.53594 +472 1 3.33848 5.81136 8.0112 0.629066 -2.48199 -2.55986 +473 1 5.22933 5.24678 6.83002 -9.21161 -10.3226 -4.65561 +474 1 5.87231 6.12998 6.73434 -14.492 -21.708 -7.10976 +475 1 6.102 5.06631 7.42095 8.16162 7.57706 8.09799 +476 1 5.11386 5.85851 7.69037 1.37823 -1.01778 -7.91082 +477 1 6.94866 5.10876 6.52261 -0.00645701 0.734687 4.76591 +478 1 7.67078 6.01392 6.41167 -4.02477 -14.728 2.57416 +479 1 7.35061 4.96205 7.5433 24.0095 -18.1944 -20.4412 +480 1 6.9284 5.83495 7.63045 -18.4707 37.5628 2.3937 +481 1 8.28984 6.85999 6.50497 12.0319 11.2505 5.01489 +482 1 0.775248 7.71516 6.80461 7.24585 -11.6558 8.08417 +483 1 0.533688 6.7762 7.54365 3.89137 -4.31915 -15.8578 +484 1 8.2465 7.61079 7.46416 25.9419 0.696332 -26.8887 +485 1 1.73177 6.71435 6.78434 -8.61422 -0.737705 -7.23833 +486 1 2.48272 7.50206 6.80041 12.0152 -3.31551 -7.82219 +487 1 2.37093 6.72113 7.64339 9.62293 -9.48685 2.94166 +488 1 1.77272 7.59226 7.58949 -2.97267 7.70343 0.621675 +489 1 3.29197 6.66554 6.74519 -6.55378 -4.76021 6.1499 +490 1 4.04728 7.44441 6.9325 9.38301 -4.09453 15.5296 +491 1 4.12674 6.55075 7.78018 3.09461 4.03017 -1.80654 +492 1 3.3807 7.43243 7.7243 -9.78058 -0.600287 9.7772 +493 1 4.74428 6.55735 6.78071 12.1641 10.0813 15.0085 +494 1 5.30209 7.56833 6.75011 8.90694 -20.2013 0.20059 +495 1 5.88783 6.83008 7.50111 -3.28565 3.55282 5.18781 +496 1 4.85536 7.429 7.66393 -0.8844 -0.824359 14.1315 +497 1 6.78323 6.58213 6.75112 16.4005 10.5566 0.00129152 +498 1 7.49771 7.53891 6.69245 -0.0692693 6.11315 -11.5276 +499 1 7.61589 6.80831 7.76686 -5.70997 -4.77696 -9.529 +500 1 6.80731 7.4637 7.45575 -10.489 5.43873 12.05 +ITEM: TIMESTEP +200 +ITEM: NUMBER OF ATOMS +500 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +ITEM: ATOMS id type x y z f_2[1] f_2[2] f_2[3] +1 1 8.41242 8.26599 8.38785 -10.0358 6.58437 5.2801 +2 1 0.814162 0.710931 0.0523899 -37.3452 31.5986 3.80166 +3 1 0.707188 8.3394 0.783901 7.22527 -6.84977 10.4166 +4 1 0.078844 0.75192 1.11978 38.2878 -8.01586 -1.83777 +5 1 1.52052 0.0613493 8.33894 50.642 -18.5757 54.2409 +6 1 2.63022 0.777198 -0.0136511 -14.6872 26.2087 -8.24369 +7 1 2.86573 8.3667 0.519039 4.98442 -20.5506 12.9041 +8 1 1.4757 0.711348 0.992341 22.4024 -8.05229 -33.8354 +9 1 3.79318 8.20698 8.14977 -12.6173 11.8638 7.05406 +10 1 4.0381 1.06879 8.36154 -11.3644 -3.77089 -31.1235 +11 1 3.94622 0.00241404 0.83531 3.0713 5.57971 3.39388 +12 1 3.2904 1.19609 0.697286 11.5663 -9.90219 11.4209 +13 1 4.80931 8.28217 0.152557 1.5084 -10.3853 -19.3359 +14 1 5.59181 0.724855 8.1093 -26.5323 12.4899 -7.60558 +15 1 5.68752 0.120676 0.713607 11.3113 1.42738 1.49966 +16 1 4.78554 0.81043 0.585131 26.0655 -22.1296 9.76004 +17 1 6.43613 0.237453 8.26775 30.1844 -14.2258 6.08634 +18 1 7.5043 0.643436 0.0691857 2.69659 0.617275 -0.831401 +19 1 7.7682 0.0476766 1.0238 2.88283 -8.74262 5.4154 +20 1 6.83111 0.459822 0.931748 -10.2254 10.6222 -23.4955 +21 1 0.00401405 1.51379 8.26626 1.73444 -9.97848 2.73777 +22 1 0.631563 2.29056 0.214422 2.30445 -4.73927 -16.4851 +23 1 0.869727 1.5347 0.919411 -20.3113 -10.6479 -1.82401 +24 1 -0.0840974 2.27001 1.15035 26.4165 13.702 -18.8298 +25 1 1.67911 1.38813 0.0883733 4.29152 4.16945 3.72554 +26 1 2.34463 2.397 8.3967 -0.661743 10.3894 16.138 +27 1 2.41792 1.69378 0.837891 -11.9994 8.17272 5.13712 +28 1 1.50784 2.3296 0.8821 15.8347 5.46342 -6.24169 +29 1 3.19181 1.77289 8.14083 -8.92279 -4.86777 22.8625 +30 1 4.12817 2.46218 8.33741 8.13153 -11.9637 0.536015 +31 1 4.26337 1.62555 0.809789 -13.061 44.2943 -8.13534 +32 1 3.42316 2.33556 0.802814 -4.29938 0.254861 -1.13643 +33 1 5.0669 1.62594 8.33933 -4.47953 5.08137 -8.2197 +34 1 5.91213 2.40952 0.124369 -13.9 -26.0969 3.99436 +35 1 6.23275 1.281 0.442008 -1.76602 1.09435 0.219677 +36 1 5.05785 2.29128 0.753897 1.63462 9.40663 2.64296 +37 1 6.76196 1.99075 8.08873 7.25593 -6.72787 12.2575 +38 1 7.89568 2.35083 0.217856 -14.3986 10.074 -11.1844 +39 1 7.7557 1.40697 0.992421 -28.0785 15.2332 -13.5573 +40 1 6.69672 2.20109 0.984157 0.465363 17.7913 -13.2761 +41 1 8.2159 3.42858 0.185567 12.3977 0.764361 -3.90376 +42 1 0.927092 4.2442 8.41258 -26.45 -26.3493 -4.33489 +43 1 0.729094 3.09987 0.813639 -4.58702 16.175 15.6607 +44 1 0.0788068 4.49033 1.02182 1.48174 1.40892 2.78463 +45 1 1.55842 3.1508 0.126599 -1.73889 6.5262 3.04002 +46 1 2.29185 4.09245 0.0493365 -0.242842 -5.39025 -0.756334 +47 1 2.41785 3.22623 0.89121 8.0106 -0.183268 -6.38994 +48 1 1.56843 4.03679 0.931375 1.76309 0.26565 -2.14494 +49 1 3.4359 3.23233 0.0225532 -4.36687 10.8322 6.25926 +50 1 4.25669 4.07361 0.0880133 2.8279 3.66932 -9.72921 +51 1 4.34048 3.08558 0.785495 -4.69141 6.70607 0.15029 +52 1 3.59299 3.90329 0.886528 -10.5717 12.5753 -2.99495 +53 1 5.13064 3.04982 8.22833 -0.225212 8.61676 17.0697 +54 1 5.81502 4.09178 8.38841 -21.2737 -2.05468 -24.8502 +55 1 5.97613 3.1773 0.894798 -5.61602 -19.9636 -19.3342 +56 1 5.09497 3.91821 0.747666 0.511602 -0.648627 8.1507 +57 1 6.51767 3.18724 8.3864 17.647 23.2966 -13.5196 +58 1 7.37164 4.03522 8.29689 -11.4262 -6.53116 -1.21962 +59 1 7.31211 3.24078 0.704535 -4.3132 -0.596821 4.84194 +60 1 6.56447 4.1734 0.602333 27.4745 -11.0091 36.7473 +61 1 8.15631 4.68203 0.075112 10.7012 -10.9934 -7.99724 +62 1 1.11663 5.88929 8.3609 -7.93077 -20.1145 9.26986 +63 1 0.996074 4.97243 1.21409 -6.72433 0.768332 -3.74364 +64 1 0.189403 5.66667 0.913187 -7.3538 -1.57168 -7.21317 +65 1 1.58163 4.94764 0.201022 19.1991 11.3216 -0.454803 +66 1 2.29237 5.73911 0.0748948 8.80602 19.0835 -4.47029 +67 1 2.49097 4.65203 0.981363 3.25616 8.72811 -9.97843 +68 1 1.87095 5.55306 0.995907 1.03553 19.7133 11.0025 +69 1 3.18407 5.012 0.131558 5.578 6.2636 9.58863 +70 1 4.09719 5.68255 0.132658 4.03261 5.63654 -2.85988 +71 1 4.12395 4.88832 0.852082 2.34539 -1.75572 -18.9743 +72 1 3.07234 5.70133 0.969327 -0.346407 5.49919 1.56796 +73 1 5.11274 5.00399 0.171908 -9.99815 3.39538 19.3609 +74 1 5.76656 5.80521 0.11529 9.4035 3.26414 21.2303 +75 1 6.01079 5.05469 0.873922 -27.3446 -31.3954 -10.6646 +76 1 4.89913 5.95208 0.960158 8.00863 4.38535 -8.86024 +77 1 6.75863 4.93475 8.31779 -18.6284 14.8779 13.2188 +78 1 7.8245 5.62001 8.34465 11.2383 14.3374 0.909184 +79 1 7.51856 5.31135 0.853265 4.91639 -9.6583 11.5193 +80 1 6.62461 5.81662 0.841147 8.94471 25.6435 -17.3923 +81 1 0.202013 6.46046 8.33455 0.0609498 5.25542 6.45446 +82 1 0.889578 7.53674 8.33221 1.62686 -1.40391 0.0530776 +83 1 0.953366 6.38848 0.908196 -1.46223 4.85455 -5.86941 +84 1 0.145952 7.39993 0.791819 5.48829 -5.75958 -9.51465 +85 1 1.67676 6.71324 8.36121 2.78795 2.25277 6.97945 +86 1 2.21164 7.54618 8.16806 16.5579 9.64776 9.50482 +87 1 2.40278 6.62803 0.856512 -0.674903 -8.3487 -4.56859 +88 1 1.53782 7.38975 0.90846 -3.10291 8.8481 -14.5459 +89 1 3.27325 6.398 0.0420856 1.14847 -3.14438 14.8868 +90 1 4.24204 7.28724 8.33928 2.62398 3.89094 44.6004 +91 1 4.04999 6.6211 0.862788 13.5756 -10.8829 -5.05866 +92 1 3.45704 7.41684 0.605416 -19.3758 10.5723 4.19592 +93 1 5.13383 6.59732 8.2884 -30.4967 14.0841 16.2852 +94 1 5.83566 7.60311 0.0824633 -14.5596 3.16754 7.91958 +95 1 5.71227 6.86684 0.81732 11.5827 -10.7391 -7.91805 +96 1 4.90381 7.61313 0.94797 9.27737 -4.87268 -6.49352 +97 1 6.72722 6.86314 0.253587 -5.2734 -0.113759 -0.620065 +98 1 7.41232 7.77996 0.331703 18.857 -4.07135 -25.363 +99 1 7.56998 6.39348 0.735875 7.28329 1.56003 -0.789213 +100 1 6.66601 7.84216 0.965777 -32.1881 -17.8038 12.8266 +101 1 0.166766 -0.00131261 1.94063 8.32296 1.94608 -3.28266 +102 1 0.934833 0.817938 1.81275 -21.8629 -14.287 17.2076 +103 1 1.00207 0.316008 2.82556 -21.807 -5.91521 -4.01431 +104 1 8.35945 0.74 2.72116 2.32177 4.37751 -0.902675 +105 1 1.48465 8.25372 1.60749 -1.18562 -7.12983 8.20441 +106 1 2.44318 0.774258 1.4766 5.48942 -2.99924 2.57908 +107 1 2.3069 8.18025 2.36522 1.41087 2.4731 2.95424 +108 1 1.85775 0.858752 2.6061 9.12182 6.5265 -4.79678 +109 1 3.23269 0.0488049 1.82801 0.784922 27.4455 -30.2613 +110 1 4.21175 0.99942 1.57195 -9.49462 -27.3711 22.4225 +111 1 4.21293 0.25409 2.38861 -7.75181 -9.25535 -4.23311 +112 1 3.32934 0.964581 2.65137 -6.01516 -9.0041 -1.19732 +113 1 4.9787 0.193499 1.50831 -4.98755 -8.3429 -3.28083 +114 1 6.09517 0.531101 1.76326 -28.5995 19.6806 -10.71 +115 1 5.85753 8.23852 2.51303 -1.20503 -8.99564 8.87124 +116 1 5.17785 0.685106 2.40543 -1.30449 11.3507 4.36005 +117 1 6.91213 8.37413 1.83271 8.62238 -24.2277 10.2354 +118 1 7.62368 0.758482 1.85178 16.0234 8.8439 -5.1341 +119 1 7.66132 8.34118 2.51601 5.03438 -8.87196 18.1761 +120 1 6.82917 0.875718 2.51872 -7.12717 1.70889 8.15245 +121 1 0.0949053 1.53257 1.83348 -15.8355 -28.5862 13.9628 +122 1 0.822415 2.21502 1.73119 16.0449 19.2167 -17.682 +123 1 0.864878 1.50475 2.57372 12.4143 -0.0682656 8.67505 +124 1 0.199844 2.34986 2.54349 -13.4424 7.82132 10.7389 +125 1 1.68463 1.52556 1.71378 7.71699 13.5023 1.83995 +126 1 2.69369 2.59616 1.91546 -20.6965 -6.26723 -3.29779 +127 1 2.60471 1.76603 2.62425 -5.19989 2.78858 2.334 +128 1 1.44056 2.43723 2.51936 11.6798 4.82752 9.65183 +129 1 3.43446 1.65477 1.84942 -9.01773 7.52097 -5.37653 +130 1 4.19061 2.39179 1.65045 11.7616 -7.21515 -2.54075 +131 1 4.26672 1.39737 2.67586 10.1937 6.39563 -7.12371 +132 1 3.53921 2.577 2.549 6.10272 -3.10086 8.1996 +133 1 5.17395 1.33784 1.40963 0.810412 -15.8822 3.29742 +134 1 5.74074 2.13809 1.54869 21.9361 25.9957 -3.59082 +135 1 5.9363 1.515 2.34901 -9.46258 -12.7333 10.9894 +136 1 4.95982 2.19781 2.39856 0.709797 0.431383 -4.3853 +137 1 6.78917 1.32128 1.47071 -5.63197 2.68115 20.8841 +138 1 7.62581 2.16504 1.87345 17.6788 -6.34038 -2.38007 +139 1 7.68847 1.62015 2.88771 -1.999 -29.1097 -18.0204 +140 1 6.72066 2.18015 2.22288 -25.5596 -3.13399 14.9826 +141 1 8.10556 3.24278 1.47587 8.10057 -1.81275 -31.7951 +142 1 0.698788 3.89936 1.58833 21.0059 -8.7854 2.84332 +143 1 0.726156 3.39424 2.59236 2.18368 -0.846434 0.375997 +144 1 8.21488 4.03893 2.09204 -9.31366 21.6556 21.1016 +145 1 1.61294 3.13444 1.56982 -6.75222 2.4564 11.7453 +146 1 2.47309 3.97186 1.76449 2.21347 -7.98753 7.5428 +147 1 2.67292 3.22702 2.95068 5.54423 5.59107 -13.8219 +148 1 1.72826 4.2557 2.53344 -3.42962 -20.862 21.8798 +149 1 3.48214 3.13902 1.56572 3.70104 11.9942 4.11222 +150 1 4.3885 3.8788 1.62665 2.95307 16.2819 -22.5535 +151 1 4.3065 3.38859 2.48531 -9.81397 -19.0665 24.4754 +152 1 3.47101 4.13314 2.35987 0.052847 -5.96917 4.43729 +153 1 5.11162 3.02695 1.57487 -2.09605 4.71156 2.60925 +154 1 6.05823 3.77666 1.6683 -0.0795953 27.02 22.5131 +155 1 5.89604 2.8633 2.33341 1.61726 0.0933652 1.12851 +156 1 5.29152 3.73349 2.43504 2.35223 15.5067 -10.4051 +157 1 6.82698 3.04592 1.66447 4.37333 2.796 -3.08497 +158 1 7.47158 4.33914 1.21316 -2.11938 -7.51647 -10.9268 +159 1 7.68828 3.1018 2.37066 -8.14673 6.79824 16.7729 +160 1 7.09384 4.0081 2.08909 -5.93874 -19.0069 4.73504 +161 1 8.1255 5.22391 1.77055 19.2122 -25.3413 6.96334 +162 1 0.62612 5.90176 1.99772 9.96713 -14.5554 -17.3464 +163 1 0.76801 4.79289 2.36504 -2.78355 1.48316 -1.85895 +164 1 8.18318 5.95034 2.62286 5.26633 -16.349 1.23379 +165 1 1.81648 4.94963 1.84319 1.29255 4.07737 -28.8924 +166 1 2.40619 6.07189 1.89723 9.11627 0.0929027 -31.5253 +167 1 2.58707 5.01704 2.50938 -14.4694 3.44726 -14.5204 +168 1 1.72272 5.71364 2.51972 -25.0056 3.38939 29.4203 +169 1 3.42498 4.85355 1.57173 -14.1697 1.2804 16.3608 +170 1 4.15303 5.79502 1.71807 -6.58651 -0.238746 -3.12281 +171 1 4.46167 4.86212 2.18786 -1.52672 -11.6836 -0.120829 +172 1 3.29589 5.94757 2.4039 5.86702 -13.0661 19.8541 +173 1 5.03295 4.96131 1.30642 14.6935 -5.33684 5.62219 +174 1 5.82775 5.80433 1.62537 -3.48018 5.04048 -3.36734 +175 1 5.79583 4.80394 2.11298 -5.34853 -5.63002 0.159279 +176 1 5.01708 6.04912 2.32216 17.4276 -29.4439 17.4564 +177 1 6.71539 5.10912 1.63093 10.3915 -7.52696 11.1074 +178 1 7.41693 5.91425 1.78268 -24.8131 17.7871 4.30264 +179 1 7.12646 4.86445 2.63426 13.6393 21.9613 3.08537 +180 1 6.42336 6.18201 2.43584 15.1603 10.9548 -7.96948 +181 1 8.23881 6.55347 1.60468 9.12903 0.565206 1.23333 +182 1 0.678624 7.37322 1.88745 -5.46988 3.49615 -25.4292 +183 1 0.794621 6.6529 2.67297 0.0873755 -1.33888 6.26964 +184 1 8.30959 7.39568 2.5723 10.9372 15.1486 20.2523 +185 1 1.53592 6.72715 1.69313 10.3025 -8.32698 21.6565 +186 1 2.52873 7.48993 1.45805 2.51224 9.72508 0.958573 +187 1 2.57516 6.97533 2.39376 0.331622 5.62636 7.11361 +188 1 1.48127 7.49186 2.513 25.359 1.87736 0.862705 +189 1 3.42472 6.67917 1.69715 -9.14691 10.5288 -4.39359 +190 1 4.07864 7.56162 1.54537 -20.7523 -1.21573 5.0956 +191 1 4.22077 6.65705 2.50099 -12.9989 13.269 2.80638 +192 1 3.32476 7.76609 2.51834 12.0821 -31.6775 22.1813 +193 1 5.18316 6.78911 1.6853 -16.2098 8.5059 -12.8052 +194 1 5.76367 7.66024 1.61411 8.21393 8.40414 -2.16429 +195 1 5.72928 6.97443 2.55641 -4.2085 8.68736 -3.41382 +196 1 4.81509 7.65411 2.27112 9.64741 4.31731 11.3389 +197 1 6.71673 6.6577 1.40921 -4.23135 13.1654 3.72162 +198 1 7.9523 7.57862 1.62003 -19.0505 2.7611 2.11499 +199 1 7.55182 6.74669 2.5625 -26.4699 -4.16644 -1.81267 +200 1 6.71006 7.32273 2.23599 -2.19037 10.3011 3.68982 +201 1 8.3209 8.25724 3.44082 -11.2006 13.9316 -31.0885 +202 1 1.1383 0.707726 3.88488 2.87074 16.2111 -29.5751 +203 1 0.710637 8.17953 4.00977 26.7141 2.01724 45.2521 +204 1 0.017483 0.84611 4.17688 -4.01486 -16.4278 3.15279 +205 1 1.83485 0.022043 3.36625 6.99225 9.16158 -10.2142 +206 1 2.5734 1.02544 3.4638 -2.67645 -0.861554 5.53773 +207 1 2.46831 8.35234 4.18841 -8.88118 2.57467 1.82808 +208 1 1.9704 0.882634 4.50547 -3.01692 -0.258051 -7.68015 +209 1 3.15194 0.11929 3.26603 1.99843 -0.203753 6.521 +210 1 4.16362 0.594977 3.39201 1.91533 3.30238 12.0146 +211 1 4.48096 8.3197 4.27248 -34.7907 27.9025 -6.28307 +212 1 3.49096 0.991035 4.39487 -18.0924 -11.2469 -3.89782 +213 1 5.15221 8.33246 3.40287 -4.49662 4.44033 -5.3065 +214 1 5.83668 0.780008 3.22544 8.18869 5.41063 4.37051 +215 1 5.71056 8.31473 4.3397 -0.683085 13.1798 -1.88784 +216 1 5.01734 0.796017 4.33297 -1.83196 10.7479 -11.7081 +217 1 6.55531 0.0226915 3.33292 8.64001 -7.40459 4.85944 +218 1 7.40254 0.734891 3.44283 9.92215 2.2266 -9.49047 +219 1 7.60175 8.41313 4.17692 -11.7492 9.12522 14.6015 +220 1 6.69717 0.884026 4.20434 -2.52907 -5.48675 3.38708 +221 1 0.266587 1.50956 3.42506 -7.49445 4.66836 1.70669 +222 1 0.834612 2.3929 3.4535 3.19311 14.9998 -2.79098 +223 1 0.966342 1.70753 4.27772 -2.38166 -3.63555 7.29451 +224 1 8.31528 2.54359 4.03878 16.7451 -1.36482 20.306 +225 1 1.65675 1.69619 3.39484 3.12529 -6.34044 -1.62009 +226 1 2.21998 2.62053 3.66497 -8.94713 -4.89956 5.05059 +227 1 2.70158 1.84855 4.22365 -4.21065 -7.00328 -1.279 +228 1 1.73069 2.39291 4.69998 -11.0397 -15.2385 -11.7518 +229 1 3.63597 1.81901 3.49635 -5.37102 -6.0004 0.428615 +230 1 4.5181 2.45307 3.50704 1.92291 5.38714 1.37796 +231 1 4.28022 1.61295 4.532 11.684 13.523 -0.759472 +232 1 3.49161 2.67545 4.21356 3.70186 4.50981 -2.53687 +233 1 5.05676 1.45985 3.45113 -18.7528 -7.6908 -2.02124 +234 1 5.59639 2.31007 3.23954 13.071 6.11501 -14.1907 +235 1 5.90515 1.58558 4.07201 2.34854 -1.44676 5.83562 +236 1 5.6448 2.61062 4.20904 5.92031 11.7583 11.4648 +237 1 6.60245 1.81532 3.22394 -0.344578 -17.0844 -10.2298 +238 1 7.7209 2.5366 3.23021 -13.9757 26.3091 7.5372 +239 1 7.59991 1.69339 4.17685 -3.31209 -2.6982 -2.62135 +240 1 6.7571 2.48096 3.97019 3.90879 12.298 15.8753 +241 1 8.32132 3.59836 3.32434 15.1974 -18.6025 -8.65377 +242 1 0.758776 4.28533 3.41911 8.12571 10.2206 -6.43372 +243 1 0.714283 3.43939 4.05789 10.8012 -17.4951 -4.32355 +244 1 8.37038 4.20103 4.16336 -19.0683 10.428 -9.16118 +245 1 1.7111 3.58985 3.37102 -4.50013 -9.39619 -9.22108 +246 1 2.7295 4.29586 3.34058 -27.7709 -28.5377 3.76594 +247 1 2.75779 3.49033 4.0215 3.07014 12.8072 -10.7423 +248 1 1.81597 4.04867 4.27403 8.34757 5.06165 3.43123 +249 1 3.63217 3.50284 3.43026 7.64322 -9.23013 -17.5251 +250 1 4.42979 4.3957 3.21235 -5.21891 -3.02116 0.669719 +251 1 4.46277 3.52681 4.13413 -5.3566 -4.51807 -16.5208 +252 1 3.52987 4.30614 4.06609 5.60483 14.7001 10.5939 +253 1 5.31574 3.44078 3.42467 1.48508 -5.70873 13.1076 +254 1 6.44336 4.14284 2.93215 -36.0911 1.99853 0.657603 +255 1 6.52296 3.60341 4.02819 -0.573509 -3.99567 -1.18998 +256 1 5.23388 4.48156 3.97453 6.55779 -4.33302 -0.590571 +257 1 6.75544 3.08581 2.98548 -20.753 -29.7898 -6.93237 +258 1 7.36113 3.83069 3.18965 17.3707 23.8596 11.1094 +259 1 7.68707 3.36428 4.36221 -8.90323 13.3285 -23.8114 +260 1 6.58157 4.70256 3.96292 -12.6487 -1.89838 -2.64764 +261 1 8.03895 4.72186 3.2072 7.03567 0.390199 -0.150374 +262 1 0.641986 5.57832 3.32415 -3.93783 9.97933 -29.9316 +263 1 0.748525 5.2954 4.26917 10.3198 11.1143 16.7142 +264 1 8.33552 6.07931 4.24855 1.05812 -13.5964 19.1647 +265 1 1.90145 4.96491 3.42288 -7.34814 1.12325 1.52157 +266 1 2.61408 5.80343 3.49254 4.58835 0.11833 -14.0758 +267 1 2.80014 5.15473 4.32615 -31.6367 11.9713 -55.3412 +268 1 1.9564 6.07585 4.27618 -9.91164 -20.8823 -47.0179 +269 1 3.37946 4.96765 3.07865 55.664 27.3093 14.9143 +270 1 4.23608 5.59453 2.88525 -18.9133 13.1689 8.33969 +271 1 4.44604 5.19737 4.14454 -7.57666 -13.265 -14.5347 +272 1 3.6416 5.84891 3.83409 2.65328 -4.22633 -4.19185 +273 1 5.15151 5.25659 3.1676 14.0924 -4.2121 3.02426 +274 1 5.82306 6.30397 3.36345 -4.54273 -6.47443 0.566248 +275 1 5.74908 5.5163 4.09569 25.3818 -3.33304 -26.8083 +276 1 4.83867 6.14359 3.79115 -4.65662 -0.583485 3.38738 +277 1 6.22614 5.32285 2.95137 -4.13422 -8.32687 15.6358 +278 1 7.32122 5.97196 3.33835 -0.00434101 -1.28454 -1.88403 +279 1 7.49659 5.17369 4.09183 8.55988 6.64783 3.63555 +280 1 6.75151 6.22479 4.25773 -16.211 -27.6787 -10.8075 +281 1 8.29215 6.64155 3.42114 5.59717 18.8581 -19.6047 +282 1 0.763473 7.56557 3.23404 -12.9198 -1.64007 -15.2341 +283 1 1.0031 6.68313 3.72439 -4.3972 -14.7662 15.3222 +284 1 8.23363 7.61771 4.35977 7.30279 -9.1197 2.90547 +285 1 1.95141 6.6466 3.21786 0.736159 0.439247 -2.07076 +286 1 2.6385 7.59536 3.37124 -4.27783 -4.21174 -0.733124 +287 1 3.13092 6.60025 4.41497 -19.4938 11.5887 -14.0245 +288 1 1.65818 7.53719 3.85187 -1.11019 -9.22082 13.1065 +289 1 3.27775 6.71474 3.27823 1.67015 1.07042 -3.65835 +290 1 4.1525 7.8844 3.3351 -7.70608 -2.7891 -4.06245 +291 1 3.98551 7.08252 4.24517 31.7093 2.51435 -5.83578 +292 1 3.40048 7.93533 4.31596 7.03572 3.0716 -3.37554 +293 1 4.94636 7.13355 3.35885 -28.0161 -11.5072 -5.66389 +294 1 5.84413 7.52046 3.45751 31.3517 19.8289 8.4284 +295 1 5.90459 6.85513 4.30093 -7.30307 7.57049 -1.80424 +296 1 5.01344 7.53745 4.4217 23.0153 -42.676 2.37557 +297 1 6.69892 6.88846 3.31402 6.29068 2.24472 -2.02408 +298 1 7.47533 7.68601 3.37673 -12.6934 -11.1052 -3.87233 +299 1 7.49921 6.86202 4.09322 12.1924 13.0141 4.3943 +300 1 6.67133 7.90635 4.38865 4.30856 -16.1011 -10.8357 +301 1 8.27296 0.0768914 5.12036 9.18301 -5.97843 0.553246 +302 1 0.892643 0.477473 4.83579 -15.0913 15.4009 20.7636 +303 1 0.772154 0.130661 5.99646 -1.43861 1.07866 -2.10387 +304 1 8.25515 0.935072 5.88754 -0.221723 -11.6722 -2.23691 +305 1 1.48963 8.06671 4.97048 16.9477 -1.8997 -3.71962 +306 1 2.57496 1.15847 5.28752 41.8653 -9.27812 4.61709 +307 1 2.98732 0.492219 6.35067 -4.54422 -4.60939 3.20868 +308 1 1.84275 0.524647 5.86961 -0.917224 0.841047 0.660751 +309 1 2.97903 0.200446 5.09803 7.97745 -0.922342 6.62523 +310 1 4.26317 0.578438 5.09777 -3.02519 11.3137 -4.68966 +311 1 4.18994 0.120263 6.02339 -4.93913 2.59189 23.6551 +312 1 3.50295 1.24619 5.79637 -4.00764 -7.55023 -4.67003 +313 1 5.12205 8.32679 5.40632 -5.25746 3.73248 -3.11501 +314 1 5.80677 0.859185 4.97868 15.281 -0.410171 8.11126 +315 1 6.05354 -0.0201647 5.97574 -7.51195 2.16668 5.49645 +316 1 5.29101 1.10125 5.89955 -0.302158 5.37706 -3.33259 +317 1 6.70998 0.244047 5.12411 -32.2188 -6.24411 4.81733 +318 1 7.52467 0.777062 4.96861 20.8677 24.3354 -3.82818 +319 1 7.29721 0.136872 5.99355 7.05953 -3.3845 7.97045 +320 1 6.54852 0.902142 6.09075 8.2259 10.3777 -12.9847 +321 1 8.3753 1.53724 4.98157 2.17311 8.15625 3.98817 +322 1 0.71432 2.51412 5.02068 -12.4966 -5.84806 3.10051 +323 1 0.855781 1.46858 5.93628 -12.4576 1.96544 0.341226 +324 1 8.11454 2.43493 5.75559 5.15623 -3.74122 1.07022 +325 1 1.70238 1.57115 5.35189 -38.5773 5.62525 -16.043 +326 1 2.46473 3.0428 4.8535 14.9609 2.21644 20.6584 +327 1 2.4829 2.11442 5.80082 20.2757 20.5564 -2.76238 +328 1 1.44662 2.4329 5.9576 0.543772 11.9562 -7.2005 +329 1 3.29597 2.05528 5.06702 2.85074 -1.27902 5.48838 +330 1 4.71392 2.67227 4.67311 -16.586 -2.70867 4.26173 +331 1 4.23981 1.93327 5.61065 17.5416 10.5589 -1.008 +332 1 3.69151 2.91031 5.72032 0.213325 2.13196 -1.69169 +333 1 5.26041 1.83667 5.02123 6.06702 -8.01086 0.159199 +334 1 6.29681 2.56022 5.09106 -5.44623 -0.683824 -15.8447 +335 1 5.97089 1.97948 5.90875 -1.39581 -8.65091 2.36208 +336 1 5.32016 2.78712 5.54952 10.0834 -7.57686 9.12967 +337 1 6.76335 1.53665 5.10381 -6.49311 3.28388 -1.62508 +338 1 7.39244 2.59867 4.94069 -6.65618 -18.4022 10.6664 +339 1 7.39034 1.59037 5.98163 7.99848 2.50507 -1.85372 +340 1 6.86792 2.60296 5.96513 8.836 -3.98323 2.68287 +341 1 0.137435 3.52069 4.93684 -4.66205 -5.7882 5.56144 +342 1 0.88525 4.34994 4.6075 2.988 -8.04302 19.8618 +343 1 0.671447 3.60221 5.79043 18.0943 -16.6493 20.2037 +344 1 8.34285 4.28087 5.95434 -19.6744 13.1619 0.969809 +345 1 1.33416 3.36295 4.99473 8.92189 5.92429 -2.5153 +346 1 2.50305 4.23267 5.05465 -27.5248 -20.908 0.492103 +347 1 2.36725 3.37012 5.84923 -17.1073 -9.96579 7.0021 +348 1 1.45211 4.29673 5.57493 7.54138 6.26423 2.50823 +349 1 3.47656 3.71778 4.99943 12.588 -10.9937 -32.8348 +350 1 4.53758 4.28685 4.7978 -5.49767 21.5926 5.59595 +351 1 4.66123 3.56451 5.54467 -12.8933 9.0868 3.25853 +352 1 3.16215 4.0016 5.8872 6.62501 12.8548 34.5501 +353 1 5.39268 3.59146 4.74919 -4.73905 -31.3011 -11.4087 +354 1 5.76113 4.47956 4.9574 18.7428 32.3973 -5.18443 +355 1 5.78815 3.80587 5.78982 -7.10304 0.117864 -2.90029 +356 1 5.02789 4.67913 5.68892 -14.5359 -3.59396 7.83253 +357 1 6.67716 3.56196 5.1655 1.61752 2.79183 -0.67852 +358 1 7.59448 4.24592 4.9803 -6.50366 -1.98045 6.72657 +359 1 7.59718 3.39514 5.76655 2.21878 7.1556 0.646608 +360 1 6.80163 4.43627 5.8851 -3.03056 -0.645399 -10.9559 +361 1 8.29576 5.01058 4.81068 0.626199 13.0736 14.2059 +362 1 1.05047 6.19551 5.02762 -0.156468 -7.32209 -14.0064 +363 1 0.578297 5.15849 5.72641 1.63655 2.26956 0.551951 +364 1 8.23943 6.07268 5.87533 8.87399 -0.526239 1.15285 +365 1 1.76527 5.31835 4.93011 -1.00084 -16.0238 11.4126 +366 1 2.88183 5.91468 5.07925 -22.1885 -17.105 2.25231 +367 1 2.65936 4.93415 6.03537 0.686882 11.6758 -2.90902 +368 1 2.03447 5.84592 5.92534 2.47635 -18.2138 -25.6325 +369 1 3.24392 4.86959 5.11086 62.6624 1.69747 54.073 +370 1 4.07402 5.91621 4.83335 -4.98562 8.578 9.29517 +371 1 3.92826 4.74513 6.11781 2.52773 6.36319 -4.5061 +372 1 3.44964 5.83627 5.89312 16.6713 -3.51566 20.823 +373 1 5.12814 5.53194 4.84592 -22.4422 -5.59515 37.2611 +374 1 5.90308 6.17208 5.1146 -12.9736 21.9443 6.65273 +375 1 5.95357 5.13374 5.81819 6.93561 8.02219 4.14964 +376 1 4.75268 5.76162 5.94655 1.5775 -0.40438 -5.87077 +377 1 6.51586 5.41565 4.90612 17.2134 -26.1979 -1.37429 +378 1 7.5279 5.93793 5.01527 -3.38884 15.9345 -12.1825 +379 1 7.6332 5.21687 5.72128 4.22628 -40.3472 -14.2075 +380 1 6.64022 6.14894 5.87989 13.3598 -6.13205 -0.934618 +381 1 8.34458 6.85129 5.15926 -14.2808 -7.95422 -4.25663 +382 1 0.833911 7.25078 4.85532 9.11386 4.17832 -8.89911 +383 1 1.06673 6.48225 6.01607 -14.203 -6.44505 8.15493 +384 1 -0.0379195 7.65497 5.88016 -1.75378 4.76646 1.63712 +385 1 2.12599 6.69323 4.98422 2.81787 34.3524 37.6883 +386 1 2.84758 7.50703 5.20442 -10.9987 17.1664 -16.5728 +387 1 2.77128 6.71691 5.85642 -9.44911 -10.1768 15.1935 +388 1 1.58013 7.32255 5.72901 16.1676 5.29147 -4.24753 +389 1 3.6768 6.91779 5.33962 13.4611 -20.8664 1.96557 +390 1 4.03881 7.88236 5.22897 2.57592 -0.812644 -11.9679 +391 1 4.4232 6.75921 6.19682 -8.5477 -5.71312 7.44018 +392 1 3.24799 7.72667 6.18249 0.719386 0.220585 -2.48264 +393 1 4.83295 6.89566 5.2507 4.97045 -2.42982 -4.77289 +394 1 5.87897 7.61282 5.14968 -20.2612 -0.49131 -22.7769 +395 1 5.75942 6.67532 6.09541 -7.34504 3.57141 -0.447292 +396 1 5.14318 7.54839 6.30602 2.0724 10.313 -0.219969 +397 1 6.74639 6.92855 5.00696 6.96871 -0.230218 1.29861 +398 1 7.3805 7.8124 5.23875 7.69485 -10.0795 -7.08489 +399 1 7.52596 6.88746 5.90198 -6.42674 1.56965 2.19774 +400 1 6.51888 7.44621 5.87193 29.4637 -7.18826 32.3539 +401 1 8.28476 0.000423359 6.72306 2.02553 19.5279 -19.3713 +402 1 1.01888 0.905848 6.82221 -28.6303 -12.8009 -18.3361 +403 1 1.24262 8.30657 7.44334 -32.4348 0.998186 -42.9826 +404 1 0.0211475 0.824091 7.47144 0.973424 -13.5355 3.24171 +405 1 1.94007 8.12144 6.72811 7.36532 0.254467 -18.2635 +406 1 3.02097 1.5587 6.75498 -16.6323 -17.6578 -2.8331 +407 1 2.39982 0.0370076 7.66598 -2.14889 1.34284 -3.48663 +408 1 1.9688 0.847456 7.09398 30.835 -18.1107 26.5169 +409 1 3.29942 8.17609 7.18194 3.78499 -8.25924 -8.09048 +410 1 3.92844 1.06207 6.75726 8.02723 -15.5891 -9.47025 +411 1 4.52946 0.167766 7.50023 3.36063 -0.839689 -4.02118 +412 1 3.29302 0.728616 7.56048 2.70434 15.6737 2.80228 +413 1 5.10415 0.332413 6.57695 -15.8309 -23.3459 -1.79261 +414 1 5.90656 0.845621 6.88018 -8.12621 13.928 11.6173 +415 1 5.71058 8.18101 7.57391 -10.3063 5.31817 -1.8554 +416 1 4.82988 1.18118 7.265 13.8593 7.32067 6.7543 +417 1 6.57919 8.43785 7.00021 11.8406 5.1504 -4.86933 +418 1 7.5282 0.806752 6.77786 -1.5451 6.42857 5.82496 +419 1 7.48349 8.33572 7.57521 5.34797 11.8467 16.9658 +420 1 6.70557 1.08836 7.47923 9.5713 -7.54062 13.1357 +421 1 0.0382442 1.56126 6.72749 -0.0966071 11.4911 -0.854867 +422 1 0.869187 2.34639 6.83989 -3.61656 -2.89703 1.60294 +423 1 0.999275 1.45672 7.67633 -8.0034 9.48038 5.5647 +424 1 0.139215 2.63275 7.64328 -15.7892 -20.5267 5.19008 +425 1 1.88893 1.53066 6.37684 -7.83006 6.68056 5.79142 +426 1 2.1935 2.73769 6.82665 18.0903 -33.7124 -24.8324 +427 1 2.37018 1.89864 7.50076 -8.8745 -17.5059 -13.2094 +428 1 1.48561 2.41457 7.71452 -8.23366 6.90197 4.22635 +429 1 3.39063 2.48859 6.68098 16.1595 11.6225 -22.1191 +430 1 4.55604 3.04369 6.47522 -16.239 -17.1818 -0.0461326 +431 1 3.92972 1.83682 7.47298 10.0225 0.0134714 -13.9461 +432 1 3.03012 2.73851 7.57823 -7.17652 4.30522 18.5475 +433 1 5.02119 2.07008 6.4546 -13.5258 -22.6225 -4.75661 +434 1 5.65211 2.81921 6.68199 10.7014 16.4385 -2.46135 +435 1 5.81386 1.77715 7.51287 -3.39579 0.139075 -0.667502 +436 1 4.71678 2.54344 7.41951 15.4924 -28.3106 -11.236 +437 1 6.66707 1.83619 6.71865 -2.24275 1.62817 8.66814 +438 1 7.65934 2.42567 6.78337 1.29364 23.1589 -24.9484 +439 1 7.60492 1.76056 7.50233 6.44148 -25.2098 19.19 +440 1 6.42541 2.6971 7.41321 1.20391 11.9169 -7.49803 +441 1 0.132604 3.18129 6.70867 -2.29445 4.14817 -3.79866 +442 1 0.662351 4.17412 6.80772 -12.4952 0.818831 -9.43638 +443 1 0.788837 3.4069 7.65946 13.9586 12.3209 -0.784492 +444 1 8.14087 4.12742 7.481 16.3072 -9.43806 5.16356 +445 1 1.48457 3.42655 6.6105 -23.5819 5.37731 -5.67472 +446 1 2.19532 4.19793 6.62241 18.5812 -12.748 4.0704 +447 1 2.03418 3.35836 7.57671 1.74798 18.3537 22.2752 +448 1 1.46881 4.26381 7.4306 10.5669 6.85755 16.1187 +449 1 3.40116 3.57046 6.96596 -19.5489 -14.8384 -6.51121 +450 1 4.14086 4.23036 7.04697 14.6332 24.1596 -34.0677 +451 1 4.37587 3.46381 7.58097 -0.667569 -11.1793 25.3659 +452 1 3.3081 4.23862 7.84495 3.59222 -23.7983 19.5534 +453 1 5.02719 3.92296 6.55308 10.3874 19.2736 1.42121 +454 1 5.99108 4.37569 6.77029 -42.1869 -21.9594 -11.1356 +455 1 5.60639 3.61515 7.4373 -8.14506 -14.6497 -3.14446 +456 1 5.05417 4.46396 7.7264 -7.96475 -5.84314 -22.6526 +457 1 6.56389 3.51182 6.41915 7.41692 -2.85266 9.06964 +458 1 7.47152 4.32616 6.69237 -6.16955 -7.38805 -5.63513 +459 1 7.53898 3.20716 7.62579 -2.06037 -6.09637 -1.14724 +460 1 6.59589 3.90993 7.45755 23.4751 -0.996001 13.7582 +461 1 8.21483 5.0816 6.83956 12.3265 -1.95746 -0.89439 +462 1 0.465403 5.98278 6.74845 -2.0373 -17.3355 -17.4636 +463 1 0.511394 5.19401 7.82937 -10.2185 -4.74355 -3.50015 +464 1 8.12271 6.05839 7.46163 -7.84524 3.1436 -8.24587 +465 1 1.48514 4.9291 6.5693 -9.22109 4.87392 -22.494 +466 1 2.40623 5.73649 6.97099 14.0591 -30.3418 -0.240996 +467 1 2.41461 4.96776 7.80425 -3.8539 -8.74065 -18.3704 +468 1 1.44923 5.49011 7.41 13.6015 -14.5185 13.7078 +469 1 3.24542 4.75566 7.0008 -15.7357 21.5396 -25.2781 +470 1 4.03587 5.88736 6.84618 18.4928 -13.3364 -12.8531 +471 1 4.10808 5.01612 7.64484 -5.1777 21.728 20.8534 +472 1 3.29694 5.8019 7.54893 0.566822 -11.9233 11.3035 +473 1 4.81889 5.07278 6.77721 5.06549 -4.43332 1.49875 +474 1 5.96641 5.77692 6.72214 -33.9279 46.677 -28.2473 +475 1 5.88193 5.34623 7.60234 -1.49551 -23.3855 17.2998 +476 1 4.83941 5.81133 7.62234 25.0546 -26.9624 -0.550707 +477 1 6.63577 5.08354 6.75153 63.1873 3.33413 5.12133 +478 1 7.44477 5.7383 6.53202 -8.94815 26.2377 30.0386 +479 1 7.45353 4.90407 7.60234 6.61529 10.6464 -15.3985 +480 1 7.05207 6.05238 7.85033 -15.5225 4.97074 -5.49642 +481 1 8.33549 6.95757 6.75022 0.367032 -2.97861 0.255273 +482 1 0.891414 7.50932 6.49478 -4.83629 2.79466 11.3618 +483 1 1.06555 6.40917 7.42656 -9.40876 15.4887 12.6203 +484 1 0.19507 7.80618 7.47535 7.27195 -18.2248 4.26121 +485 1 1.90915 6.5235 6.63557 -10.6214 46.709 18.7487 +486 1 2.60482 7.35009 7.06318 -2.87326 8.86923 -10.12 +487 1 2.54785 6.52686 7.66612 -14.5904 -1.60347 8.59865 +488 1 1.54201 7.28494 7.4147 7.26892 14.9372 -8.95427 +489 1 3.42163 6.7113 6.72693 -9.74068 0.0780566 2.81617 +490 1 4.07503 7.52705 6.85904 11.3718 5.59625 6.13428 +491 1 4.17032 6.5317 7.69612 -24.7224 6.99609 -12.8841 +492 1 3.30541 7.28919 7.8835 -6.45113 3.62128 -9.60987 +493 1 5.18135 6.6767 7.03146 3.30189 -12.2169 -7.11599 +494 1 6.1441 7.48882 6.87735 -8.40006 -9.95553 -2.76953 +495 1 5.99111 6.52776 7.79328 26.4283 6.66779 -19.7705 +496 1 4.88188 7.45813 7.61707 18.1033 18.9899 -14.9739 +497 1 6.70265 6.55612 6.94114 4.37785 1.73726 -4.76735 +498 1 7.52255 7.69097 6.78657 -11.7433 -15.8982 -13.9562 +499 1 7.60662 7.23551 7.85952 12.3776 -11.2962 -9.39843 +500 1 6.63368 7.62048 7.85195 7.88485 3.15928 -11.7162 +ITEM: TIMESTEP +300 +ITEM: NUMBER OF ATOMS +500 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +ITEM: ATOMS id type x y z f_2[1] f_2[2] f_2[3] +1 1 0.233349 8.13006 8.37458 -13.2268 13.2109 8.94155 +2 1 0.896766 0.85308 8.30255 3.22629 3.6978 6.45643 +3 1 0.859864 0.0707018 0.945242 -23.4126 -16.0712 -18.9613 +4 1 0.0588758 0.842768 1.07285 9.62638 -2.91549 -12.4893 +5 1 1.77938 8.21846 0.149185 -27.8434 -16.3109 -1.32989 +6 1 2.24018 0.700289 8.36085 16.269 9.92358 -3.41709 +7 1 2.6315 8.21417 0.711168 13.3859 0.245092 -3.82819 +8 1 1.39092 0.935915 0.985394 12.7346 13.01 -5.10945 +9 1 3.3176 8.39636 8.17869 -11.566 -16.9274 13.6338 +10 1 3.85219 0.815062 0.0370236 10.4004 28.9589 -3.67884 +11 1 4.161 0.0319779 0.627546 1.75904 -7.59281 -2.75644 +12 1 3.11636 0.817642 0.847547 4.80203 -27.6102 -6.44654 +13 1 5.13793 8.3571 8.28888 -5.17208 4.97346 2.0085 +14 1 5.70385 0.905818 8.12031 -17.8373 19.4407 -6.83741 +15 1 5.79877 0.0963845 0.817928 -4.38032 -1.5507 0.666839 +16 1 4.98412 1.21117 0.664665 -21.555 -8.66432 0.346644 +17 1 6.45061 0.296088 8.38812 3.42924 -28.9348 -2.0588 +18 1 7.77702 0.350545 0.295684 -0.731277 11.544 -2.82186 +19 1 7.70462 8.17101 1.16161 -8.03851 17.5755 -13.9844 +20 1 6.86494 0.586624 0.875444 5.58847 2.16197 13.2587 +21 1 0.100678 1.61145 0.0186749 -1.1873 -11.6656 4.66894 +22 1 0.998429 2.3998 8.22988 -7.28085 -4.5005 5.89326 +23 1 0.828996 1.87962 0.867267 -19.2592 -9.93125 -3.90703 +24 1 8.27374 2.4894 0.580898 8.78255 -11.7455 7.53659 +25 1 1.74048 1.62493 8.26739 -9.18296 -12.9889 2.92816 +26 1 2.39558 2.37629 0.0600193 9.87685 24.4855 1.90731 +27 1 2.45445 1.58898 0.877492 -32.2642 -6.64837 2.63885 +28 1 1.65243 2.45558 0.846906 19.966 -6.37675 -0.113589 +29 1 3.02408 1.54485 8.35689 5.59986 -7.64836 -2.85923 +30 1 3.92 2.20197 8.38732 -20.8443 12.2841 2.52306 +31 1 3.77985 1.57027 0.846646 20.9907 13.6119 -1.22324 +32 1 3.10388 2.34584 0.944358 6.32701 23.9593 -3.77688 +33 1 4.85706 1.878 8.25981 8.11354 -3.87323 -9.47245 +34 1 5.78268 2.09333 0.29673 -1.36849 16.4599 4.03726 +35 1 5.97863 1.20376 0.790291 32.0463 2.36619 -11.4383 +36 1 4.88385 2.45634 0.850397 9.78281 -16.7958 -1.62774 +37 1 6.62285 1.61835 8.29579 8.05661 -4.4773 5.02204 +38 1 7.55399 2.56197 8.18132 12.8994 -8.38166 15.4695 +39 1 7.59924 1.47112 0.768275 -0.340381 -2.67871 -5.54587 +40 1 6.74877 2.64386 0.753723 -17.0902 -18.9793 -10.4389 +41 1 8.35722 3.30339 8.29621 3.88209 -7.05803 1.13469 +42 1 0.765977 3.99405 0.477073 10.4517 2.49603 -17.2656 +43 1 0.831221 3.06707 0.900453 -8.35587 -6.78904 7.02328 +44 1 0.140436 4.39767 1.19127 -1.57081 11.5239 1.23833 +45 1 1.55351 3.27393 8.36662 -0.118073 6.26889 7.92677 +46 1 2.48303 4.16731 0.14908 -13.7582 -4.26857 1.92322 +47 1 2.37333 3.17517 1.02067 -14.4692 6.50264 -31.5071 +48 1 1.65701 4.17058 1.15287 -1.5797 -1.97941 -12.8817 +49 1 3.21438 3.21157 0.146996 -20.1594 -11.7694 11.9952 +50 1 4.28321 4.06082 0.235561 -7.01013 0.464645 -7.4456 +51 1 4.00184 2.96868 0.822048 -4.54826 25.7516 -18.5713 +52 1 3.26412 4.08833 0.821613 11.1851 4.36305 6.27367 +53 1 4.93889 3.19103 0.0459746 -2.17639 -1.1271 -7.48927 +54 1 5.93535 4.0528 8.21654 -1.56333 -1.65165 1.96928 +55 1 5.75576 3.15988 0.707778 17.6817 -13.2713 5.13403 +56 1 5.2315 4.02943 0.763223 -0.452475 -6.04463 7.12931 +57 1 6.80967 3.18308 7.98158 -23.2698 3.29018 18.9116 +58 1 7.84937 4.15894 0.139115 -10.2897 11.6744 2.993 +59 1 7.56351 3.24008 0.752033 -0.468845 18.0521 -12.3044 +60 1 6.70326 3.88955 0.624889 -0.941138 0.59008 2.25635 +61 1 0.263315 4.89557 0.260533 -21.3177 5.01328 -15.5704 +62 1 0.767954 5.80979 8.30607 7.59978 -5.84563 1.67074 +63 1 1.01162 5.03409 0.908989 7.54529 2.69929 16.3999 +64 1 8.38725 5.83431 1.00337 3.61589 -4.15339 -6.36164 +65 1 1.65923 4.84747 0.0732901 -12.2718 -7.14452 -1.11973 +66 1 2.34253 5.60198 8.30655 7.91513 22.3685 24.006 +67 1 2.47075 4.92775 0.922768 -5.69599 3.89765 2.66746 +68 1 1.65076 5.8624 1.08155 8.28384 13.1663 -26.7168 +69 1 3.21032 4.96288 0.0718385 6.90275 12.0583 4.83562 +70 1 4.31683 5.81091 8.2445 -6.07106 16.001 24.4162 +71 1 4.0022 5.10933 1.08243 -0.987394 -5.51353 -4.14418 +72 1 3.08952 5.8543 1.08001 20.7019 -13.8856 -23.646 +73 1 5.04193 4.8848 0.236201 -6.75887 8.84809 -11.6728 +74 1 6.01036 5.86922 0.147762 0.616812 -0.708561 -9.8882 +75 1 6.00591 4.76669 0.704892 -5.00399 3.30231 -11.9912 +76 1 5.15986 5.7957 0.727818 -36.1273 9.99449 -4.0864 +77 1 6.87642 4.89744 0.140008 2.16293 1.86546 -13.7103 +78 1 7.84039 5.5603 8.24691 -4.77039 2.45387 6.97935 +79 1 7.61247 4.95216 0.884224 61.5464 5.54866 -31.4574 +80 1 7.13999 5.87097 0.66837 -10.4004 0.446979 -1.0889 +81 1 0.284976 6.68434 0.215945 -19.2498 8.05662 -14.0567 +82 1 0.982876 7.472 8.30358 11.1034 -5.67626 13.795 +83 1 0.874256 6.63686 1.03265 -11.7399 -6.70777 -2.09767 +84 1 0.12523 7.53526 1.06205 -15.5002 -8.52158 -32.9301 +85 1 1.53836 6.56542 0.124336 5.81155 -2.74575 2.70263 +86 1 2.45566 7.24014 0.163939 -13.7862 7.0524 3.90305 +87 1 2.38368 6.64181 1.16489 5.19309 13.0368 -14.4547 +88 1 1.55777 7.42064 0.955187 2.95317 9.919 -9.12596 +89 1 3.26105 6.57879 0.277391 6.19764 -3.88127 -4.29904 +90 1 4.21681 7.50418 8.36589 0.418779 7.33048 -0.673966 +91 1 4.2136 6.71573 0.805769 6.02261 -2.81289 0.798739 +92 1 3.49573 7.57967 0.77094 -13.8185 -15.1907 -22.6007 +93 1 4.97943 6.65519 6.77102e-05 6.49698 2.41559 -0.5205 +94 1 5.78763 7.50739 0.0292034 7.17211 6.93093 1.18788 +95 1 5.70061 6.80412 0.815144 6.83872 -8.02569 -5.22668 +96 1 4.96155 7.64188 0.754906 -1.40971 0.48378 3.60676 +97 1 6.62543 6.75834 0.212141 20.3815 -6.72799 19.0936 +98 1 7.5054 7.54064 0.228699 5.02405 -0.59125 8.31674 +99 1 7.62741 6.7648 0.966544 10.8528 -1.51524 -6.86782 +100 1 6.51764 7.61106 0.794066 -3.58188 15.2202 -2.22905 +101 1 0.0861403 8.39942 1.77523 16.561 5.47177 12.0456 +102 1 0.798241 0.867486 1.90283 5.83429 -6.22483 -1.18959 +103 1 1.01882 8.16093 2.58804 1.69129 37.21 2.68102 +104 1 8.26047 0.933232 2.39213 16.6191 -6.94084 19.3019 +105 1 1.5043 8.31602 1.70005 24.5225 8.22354 6.48742 +106 1 2.3278 0.505699 1.44491 -1.87805 7.24432 12.5632 +107 1 2.30107 0.0675885 2.61736 -2.34035 -25.4089 0.204635 +108 1 1.65389 0.877547 2.65941 -7.28266 6.33447 -16.1438 +109 1 3.50019 8.31721 1.47862 -16.7888 14.1081 10.898 +110 1 4.01956 0.825924 1.54962 -26.8746 12.2857 6.16059 +111 1 4.07538 0.019132 2.44171 -4.87493 0.404402 -2.17065 +112 1 2.869 0.885962 2.4149 5.17917 -2.47967 0.533766 +113 1 4.73464 0.155071 1.4932 30.6868 -26.2406 6.98684 +114 1 5.62968 0.817396 1.64834 -4.04481 -8.77462 16.8173 +115 1 5.66865 0.0141325 2.50366 17.0023 -1.89327 -13.9307 +116 1 4.86842 0.817468 2.42132 32.27 -13.4362 -6.77265 +117 1 6.59541 8.31415 1.73549 -0.21361 15.3936 4.52423 +118 1 7.59767 0.742823 1.6565 -21.3952 4.75735 -8.6823 +119 1 7.60945 8.3635 2.38741 -3.47518 -4.35582 8.08118 +120 1 6.64964 0.766964 2.59458 1.86331 7.94862 -15.7507 +121 1 0.0966564 1.72383 1.66126 -2.3646 2.96568 -2.77323 +122 1 0.838875 2.52792 1.96878 -8.15441 10.7797 -1.95863 +123 1 0.90776 1.65168 2.68747 -10.1162 -2.78056 -2.47535 +124 1 8.34426 2.2614 2.55151 21.19 -10.0612 15.2043 +125 1 1.46427 1.72978 1.76157 8.28796 -9.22695 -3.48387 +126 1 2.37501 2.29161 1.76614 -0.0664736 7.90276 1.49641 +127 1 2.67166 1.85508 2.81423 -4.33867 8.71682 -6.36279 +128 1 1.69129 2.40006 2.69001 -6.84808 74.503 -77.1336 +129 1 3.2606 1.69371 1.92128 -6.02725 -3.6159 -16.3817 +130 1 3.94104 2.38885 1.63591 5.99851 11.0997 18.049 +131 1 4.04449 1.32304 2.52718 -28.9333 17.8748 13.0885 +132 1 3.64404 2.34301 2.71879 -4.29604 2.09188 -4.97764 +133 1 4.64091 1.6418 1.58405 19.1918 -0.189122 5.88078 +134 1 5.88395 2.31133 1.52544 0.0797298 5.40617 -9.4435 +135 1 5.7987 1.64961 2.35436 -3.46325 -3.79932 12.9903 +136 1 4.78244 2.22308 2.51874 2.01011 -1.75623 -4.81914 +137 1 6.65439 1.55727 1.69251 0.0481382 -10.7878 -2.86985 +138 1 7.4609 2.22018 1.51079 9.36137 15.4008 -1.67913 +139 1 7.50576 1.63853 2.4128 -2.97032 -17.2864 -0.621812 +140 1 6.87214 2.43415 2.42038 -30.5876 3.19651 2.74052 +141 1 8.27498 3.12542 1.46263 16.9155 1.32854 13.6822 +142 1 0.778659 3.95642 1.86807 -7.25106 -12.2522 -5.40095 +143 1 0.798965 3.10856 2.99966 -8.51883 26.4353 -21.6316 +144 1 8.39629 3.85082 2.58225 -5.99614 1.48776 4.40527 +145 1 1.68381 3.21805 1.79101 -5.77633 -5.0861 7.47296 +146 1 2.56903 4.03114 1.71918 -6.92524 18.9919 2.42009 +147 1 2.68821 3.054 2.58052 -0.955464 -0.812242 -0.180548 +148 1 1.68992 4.20726 2.20027 5.368 3.11181 32.2719 +149 1 3.19042 3.29104 1.54336 50.4233 -29.9172 14.5641 +150 1 4.30208 4.0236 1.30142 -3.92395 -1.77865 11.4065 +151 1 4.28898 3.18994 2.59219 8.96711 6.3942 -10.7611 +152 1 3.60727 4.0096 2.21837 0.742083 4.13896 4.48687 +153 1 5.11886 3.09922 1.66619 -2.87182 6.36609 5.71268 +154 1 5.98984 4.3721 1.6574 7.23512 -22.1503 15.9695 +155 1 6.06757 3.38048 2.48886 -0.631751 -1.09061 1.54872 +156 1 5.04095 4.05582 2.29794 7.98224 -6.57422 -3.38111 +157 1 6.80585 3.23363 1.61955 1.81547 4.43083 5.90353 +158 1 7.6107 4.12271 1.4985 -13.6918 -18.0547 7.51636 +159 1 7.71076 3.00605 2.3508 1.14441 21.4666 -12.0177 +160 1 6.92831 4.10176 2.31565 -3.92153 2.58619 4.8482 +161 1 8.33973 5.1724 2.08404 -22.306 -14.8391 -35.8531 +162 1 0.860537 5.83051 1.79504 -25.5953 10.3696 1.23396 +163 1 0.802813 4.96181 2.52052 20.0549 -14.1798 16.2425 +164 1 8.20479 5.88748 2.7573 8.86056 43.8975 -14.7096 +165 1 1.62556 5.15881 1.79421 13.6671 -60.0224 -43.8322 +166 1 2.44832 5.82052 1.83706 -21.0979 -8.85922 15.9808 +167 1 2.35829 4.95884 2.60055 5.56499 -3.25718 -17.7316 +168 1 1.57047 5.68188 2.57793 3.26945 48.3874 60.3367 +169 1 3.12962 4.94115 1.79611 3.44797 3.66295 -7.67081 +170 1 4.533 5.88518 1.61818 -3.82507 3.84853 0.541056 +171 1 4.41047 4.91386 2.27111 -7.04817 9.97354 -0.554451 +172 1 3.1705 5.97206 2.56867 13.8835 0.36015 7.54685 +173 1 5.10201 4.84379 1.45925 -8.99072 13.7146 -7.42642 +174 1 6.04077 5.71462 1.17105 24.8221 7.94918 20.2395 +175 1 6.02655 5.34395 2.16117 8.67798 2.32994 -0.236737 +176 1 5.13754 6.13757 2.45889 -19.0768 2.88926 -22.199 +177 1 6.81157 4.98564 1.3948 -36.2833 4.79272 33.0954 +178 1 7.60086 5.99469 1.7372 -3.24829 -8.45789 -2.93345 +179 1 7.33283 5.34101 2.57932 2.07328 -12.097 -6.46632 +180 1 6.77196 6.24125 2.34214 -17.3674 -5.70799 13.1243 +181 1 0.0250537 6.6606 1.72753 8.49396 4.93702 8.33356 +182 1 0.795762 7.59079 1.77266 12.7999 -27.3678 15.1487 +183 1 0.926657 6.70523 2.69571 -0.793657 3.91691 -3.18748 +184 1 0.160908 7.59778 2.74546 -5.44053 4.97464 -19.9661 +185 1 1.54893 6.69469 1.77147 8.37496 4.15768 30.0144 +186 1 2.38553 7.66265 1.59156 1.85092 -2.31642 6.75994 +187 1 2.52893 6.74213 2.34554 9.20138 12.1517 -25.6716 +188 1 1.80175 7.4451 2.61158 -6.78811 17.5009 -13.1399 +189 1 3.38458 6.74038 1.57533 -10.1646 -3.59545 3.61897 +190 1 4.095 7.47851 1.58866 27.0187 15.4009 2.51878 +191 1 4.11379 6.83 2.37783 19.5598 -18.1657 -14.1463 +192 1 3.12959 7.71074 2.36405 10.6634 -2.49932 -15.2866 +193 1 5.08729 6.94297 1.62592 -21.1801 -24.4484 5.07107 +194 1 5.73581 7.71377 1.57745 5.16642 11.3097 -0.890489 +195 1 5.92001 7.08484 2.45291 -0.193261 -0.933403 -1.70059 +196 1 4.83819 7.59024 2.39768 8.18574 14.9342 11.0206 +197 1 6.61545 6.66525 1.38958 -18.6406 -25.8802 -11.2439 +198 1 7.15994 7.45994 1.57935 11.6501 4.19084 33.778 +199 1 7.56748 6.9114 2.40976 10.0926 4.81165 9.43494 +200 1 6.80428 7.72449 2.78938 -1.24224 -1.60677 -10.8659 +201 1 0.159784 0.136544 3.24366 -1.32953 4.05967 1.66335 +202 1 1.00698 0.811307 3.51207 1.50245 1.78035 6.01503 +203 1 1.34713 0.12551 4.66914 -24.521 -31.0514 3.16868 +204 1 0.0655245 0.668593 4.25847 -0.855275 2.59789 -3.35749 +205 1 1.74942 8.37675 3.57933 -10.207 -16.1779 -1.21978 +206 1 2.26863 0.82911 3.48792 22.6881 17.8048 9.09595 +207 1 2.33553 0.183914 4.4711 16.8323 -1.13179 -15.08 +208 1 1.7049 1.03332 4.4695 6.78822 33.3459 -7.07653 +209 1 3.29237 0.411287 3.32326 -2.12858 -4.79866 -0.866625 +210 1 4.21141 0.796867 3.72276 15.2258 15.2508 -15.0202 +211 1 4.33441 8.33993 4.30342 13.6521 7.25398 3.1725 +212 1 3.45786 0.725922 4.42039 -13.4693 -6.1715 4.46767 +213 1 4.89231 0.0473082 3.15782 -6.25621 1.30634 20.3282 +214 1 5.77362 0.736119 3.37748 -9.09312 1.23928 -13.4649 +215 1 5.99071 8.04065 4.47949 -15.8189 13.2428 -8.46949 +216 1 5.196 0.682234 4.2587 4.7081 -6.90451 -0.266688 +217 1 6.57106 0.145322 3.40637 19.3462 -23.2913 17.9258 +218 1 7.59401 0.663732 3.46257 -2.8602 2.11131 -2.24016 +219 1 7.44242 8.25412 4.2449 1.11307 19.9225 9.74876 +220 1 6.62382 0.709572 4.35284 3.66026 3.16927 -3.64727 +221 1 0.0779483 1.38159 3.37319 -4.4953 5.38733 3.01304 +222 1 0.974278 2.30233 3.53228 -23.5961 -13.9704 29.7447 +223 1 0.524182 1.77379 4.53785 8.44119 -12.0369 -19.76 +224 1 8.32657 2.54461 4.19453 11.685 -8.01921 4.29442 +225 1 1.79699 1.78778 3.36592 20.9053 -94.2146 75.3552 +226 1 2.26904 2.65097 3.69138 3.64635 0.74501 -3.21688 +227 1 2.67429 1.70202 4.43144 -1.62218 -6.52331 -3.16444 +228 1 1.67869 2.25152 4.52595 21.8057 -26.9163 -24.6655 +229 1 3.42529 1.64095 3.50559 7.24234 -14.969 7.63922 +230 1 4.36843 2.51227 3.48596 2.07064 -5.87084 11.4812 +231 1 4.83369 1.71242 4.31187 -12.4342 -5.24453 -2.55025 +232 1 3.42697 2.55135 4.03879 13.1661 -11.4647 -6.22039 +233 1 5.09889 1.5127 3.30322 -10.1348 7.40169 -7.59726 +234 1 6.05204 2.45182 3.35855 -5.34479 4.21286 -4.99107 +235 1 5.91247 1.54121 4.03978 -1.19872 3.24833 9.47786 +236 1 5.34566 2.59829 4.30389 3.31953 7.26855 -16.7286 +237 1 6.74657 1.65018 3.27179 -23.12 -29.0051 -3.67746 +238 1 7.53263 2.23686 3.30386 26.344 22.8452 7.39879 +239 1 7.49613 1.58204 4.21155 10.9589 -18.8504 -4.35663 +240 1 6.70452 2.2326 4.19472 -13.7578 19.073 -7.70781 +241 1 8.04948 3.18864 3.48276 7.81989 17.0755 -15.6642 +242 1 0.420364 4.02026 3.62891 2.0762 -18.0048 -13.8871 +243 1 1.02911 3.20723 4.10028 2.87528 5.61338 3.46722 +244 1 8.23518 4.59996 4.24867 -9.72892 -14.3069 11.6196 +245 1 1.79813 3.62221 3.14835 -2.38332 -26.1643 0.00682256 +246 1 2.74246 4.09054 3.06778 10.2172 -0.241531 -5.01738 +247 1 2.65108 3.56469 4.0066 1.29528 2.95166 -0.450344 +248 1 1.68753 4.16642 4.41008 0.531244 0.36282 -0.905409 +249 1 3.56157 3.26659 3.34031 -15.156 16.0178 -13.2173 +250 1 4.30786 4.20161 3.07587 -3.71718 9.6458 -20.0534 +251 1 4.29173 3.71129 3.93288 2.63232 -25.6185 20.4798 +252 1 3.34785 4.41255 3.95574 4.30294 0.337698 1.30747 +253 1 5.19196 3.15058 3.27975 2.68017 7.34728 -0.723223 +254 1 6.11836 4.37563 3.09786 3.48097 -0.455645 -7.15348 +255 1 6.16379 3.4966 3.8024 -0.493793 0.0328113 2.1336 +256 1 5.30251 4.52711 3.80393 -16.2632 -25.1941 -0.0075048 +257 1 7.08947 3.30091 3.10932 -23.6486 5.19633 4.56168 +258 1 7.44697 4.43668 3.27896 -0.511887 -2.93371 -0.292771 +259 1 7.26132 3.68038 4.11877 19.5278 5.77559 -31.2062 +260 1 6.65227 4.59556 4.02535 -2.98634 0.729124 1.77093 +261 1 8.32438 5.07972 3.31456 7.45197 -18.3523 8.49382 +262 1 0.7239 5.87238 3.35063 13.9037 -7.68163 -11.6827 +263 1 0.86133 4.86733 4.0112 5.23908 17.06 9.33784 +264 1 0.110376 5.99228 4.15088 -19.5006 -5.14624 15.1727 +265 1 1.63326 4.60922 3.31023 -1.76723 17.8491 2.08855 +266 1 2.40135 5.61695 3.38494 19.4662 4.44663 -11.3673 +267 1 2.36184 5.08435 4.31966 -1.81965 -14.9274 -8.60789 +268 1 1.71701 5.94552 4.03684 -24.0402 -0.0953197 5.79012 +269 1 3.43912 4.9954 2.79577 7.89838 -10.7079 17.2388 +270 1 4.22838 5.86109 3.02821 33.6181 3.37383 -45.0173 +271 1 4.24887 5.06359 3.71273 2.64953 -0.546445 2.15952 +272 1 3.55742 5.92395 3.71083 -38.5919 -3.44905 39.4056 +273 1 5.41837 5.23828 2.98577 -11.447 -4.74628 10.7983 +274 1 5.86494 6.22754 3.11739 14.9731 7.40151 22.8162 +275 1 5.75467 5.37436 4.08221 13.6205 23.921 6.83069 +276 1 4.77382 6.13694 3.95439 -2.74813 -13.8938 10.4295 +277 1 6.55906 5.4789 3.24844 0.234698 -8.05013 11.4476 +278 1 7.53331 6.151 3.48116 -10.0459 9.16913 -20.7264 +279 1 7.59712 5.40949 4.12314 -10.2706 -23.4933 17.211 +280 1 6.76315 6.15422 4.20451 -8.32818 -2.13306 4.306 +281 1 8.33074 6.79274 3.30017 10.9969 -9.86444 14.3566 +282 1 1.03943 7.60681 3.41422 12.8839 -22.0033 7.43641 +283 1 0.876997 6.68124 4.1033 12.4942 12.9257 -7.86127 +284 1 0.320289 7.62896 4.11358 -19.9566 8.93301 7.64028 +285 1 2.12233 6.73507 3.25947 -6.36672 -13.9408 34.1069 +286 1 2.9278 7.71082 3.35699 -9.10575 13.9767 3.53664 +287 1 2.86555 6.96099 4.04549 -8.29151 -16.9355 4.68952 +288 1 1.89553 7.49272 4.25249 -6.95602 2.25366 -4.36835 +289 1 3.55128 6.82828 3.17739 -22.1877 4.18931 17.356 +290 1 4.1661 7.71123 3.4095 -5.10369 -4.69259 -0.796458 +291 1 3.89274 6.87937 4.19693 15.4298 1.82254 7.44647 +292 1 3.39266 7.95134 4.30177 -1.7872 -21.2114 -27.9517 +293 1 4.99714 6.86548 3.27273 -3.15325 15.5146 -9.80269 +294 1 5.7604 7.67976 3.37293 2.05238 1.22428 3.6757 +295 1 5.73479 6.76996 4.15088 6.33474 -4.66485 -1.392 +296 1 5.07616 7.57695 4.40446 -13.6351 -7.42167 0.514113 +297 1 6.73778 6.81794 3.33301 -3.54485 0.402493 -5.08336 +298 1 7.71498 7.67053 3.44695 -0.752689 -3.6099 -11.6949 +299 1 7.71759 6.87965 4.22182 -5.11403 5.07303 3.22293 +300 1 6.7649 7.45476 4.17956 6.56157 -12.3801 -0.724651 +301 1 8.19197 0.136233 5.17288 2.67067 20.6746 -19.9914 +302 1 0.776102 0.931351 5.08619 -1.70464 -8.91233 1.85235 +303 1 0.888781 0.0179834 5.65999 -4.55543 21.0031 13.534 +304 1 8.38466 0.737331 6.00004 -6.63761 5.81892 -3.68334 +305 1 2.17326 8.16764 5.48567 -30.0571 8.40977 9.50779 +306 1 2.68565 0.975823 5.34104 11.1467 5.8174 -19.2362 +307 1 3.06444 0.336871 6.1128 1.74673 -5.08128 15.5867 +308 1 1.94778 0.751629 6.0231 -12.5402 -6.77103 11.9096 +309 1 3.09215 -0.0018856 5.12048 23.3711 9.80891 31.3016 +310 1 4.54285 0.96074 5.03055 -10.8439 -8.47943 8.00065 +311 1 4.19772 8.25187 6.2874 -2.87662 7.25597 -11.3947 +312 1 3.73883 1.45482 5.73884 -5.31372 -3.16529 -7.8226 +313 1 5.15615 8.35466 5.42348 2.42368 -1.79965 -6.24325 +314 1 5.91471 0.891384 5.15303 -5.07011 -3.09253 -0.460458 +315 1 6.03745 8.35632 6.14961 -1.39208 3.8678 -5.18235 +316 1 5.2121 0.86593 5.98804 -13.8254 0.446509 -12.536 +317 1 6.68868 8.34181 5.14194 3.9888 6.48649 16.9974 +318 1 7.34021 0.809849 5.26372 -2.78853 -11.1974 -10.3326 +319 1 7.36245 8.30575 6.05369 1.98185 25.0408 -10.0092 +320 1 6.64158 0.85851 5.99168 -3.68623 1.19752 6.36998 +321 1 8.13309 1.40671 5.10096 17.8835 4.45702 -4.02515 +322 1 0.892662 2.59499 5.00421 -20.8235 21.437 24.4928 +323 1 0.773043 1.57142 5.91415 4.22614 9.86073 2.56515 +324 1 8.33239 2.57823 5.60038 -0.623629 0.0892147 1.2306 +325 1 1.87225 1.66498 5.43985 -2.48264 -4.0236 -4.58226 +326 1 2.75473 2.72259 4.73435 -30.311 11.1987 -1.55273 +327 1 2.93165 2.12687 5.49641 -1.73472 -35.7803 16.6222 +328 1 1.7335 2.58373 5.90704 -3.71318 12.7214 1.30751 +329 1 3.77896 1.69526 4.65032 1.63977 11.6216 2.36832 +330 1 4.33882 2.78478 4.62298 7.45227 7.00188 -24.1667 +331 1 4.0935 2.44339 5.52545 -11.3615 -7.17888 20.8862 +332 1 3.18285 3.03749 5.86709 11.7107 14.2608 -10.1303 +333 1 5.16253 1.77254 5.33362 4.38648 8.73211 2.03951 +334 1 5.9743 2.78241 5.0854 16.8461 0.569184 7.37091 +335 1 6.05449 1.8557 6.00418 -1.07841 -2.85482 0.754485 +336 1 5.02736 2.93607 5.49369 -0.394928 -5.32288 -0.0457358 +337 1 6.65738 1.68333 5.09298 2.04945 -3.50949 1.46808 +338 1 7.506 2.4535 4.81544 -2.36267 6.50792 21.426 +339 1 7.5049 1.81157 5.81254 2.0705 -7.66144 9.63716 +340 1 6.81799 2.57614 5.74327 -5.22025 12.4071 0.584392 +341 1 8.08209 3.4329 4.82809 -0.388102 0.733533 -0.302449 +342 1 0.687603 4.05264 4.91973 13.3113 7.10483 -26.1293 +343 1 0.927182 3.40713 5.70883 1.42 -2.21252 8.41121 +344 1 8.39125 4.08596 5.64374 -17.7983 3.69834 21.9629 +345 1 1.85335 3.18328 4.91159 -22.5662 10.1648 8.61749 +346 1 2.62594 3.83741 5.0269 -11.5374 29.2389 12.1219 +347 1 2.23001 3.64598 5.99431 12.2251 -19.0314 6.6066 +348 1 1.61612 4.36322 5.62412 -4.72812 -41.6645 3.65456 +349 1 3.49026 3.4159 4.80384 34.5623 1.92174 -9.26957 +350 1 4.42781 4.48169 4.58587 2.89283 12.0072 14.2383 +351 1 4.32987 3.73273 5.40213 -1.15236 0.923586 4.29704 +352 1 3.35747 3.99106 6.24745 4.6285 19.5949 -5.94829 +353 1 5.1733 3.66262 4.57851 -0.760359 -3.40804 -5.73178 +354 1 5.75745 4.60154 4.93992 12.48 38.3619 -39.183 +355 1 5.60952 3.84508 5.51193 1.72033 -36.6996 37.1733 +356 1 4.90838 4.64872 5.58962 -7.33472 10.9707 -1.22542 +357 1 6.81366 3.55073 4.97382 -24.7572 -16.3635 34.7513 +358 1 7.36231 4.42367 5.08055 17.1166 2.62568 -2.95463 +359 1 7.4725 3.41969 5.92572 4.71216 -0.444272 -3.67252 +360 1 6.56495 4.37474 5.82163 -0.033274 -9.82017 -6.2351 +361 1 0.041011 5.18659 5.08838 -22.5443 6.51501 -27.8507 +362 1 1.02655 6.1046 4.9959 -2.55187 -8.42255 -9.06362 +363 1 0.725543 4.91454 5.73466 12.2313 -2.94426 20.5318 +364 1 0.0422288 5.86356 5.87032 0.0942915 12.4442 -1.56822 +365 1 1.61098 5.19782 5.1268 2.44581 33.2387 -21.9348 +366 1 2.65636 5.69092 5.09384 11.8609 0.215073 14.2086 +367 1 2.6104 4.85981 5.98721 5.66035 -5.70161 -4.77737 +368 1 1.90538 6.1737 5.70769 -41.2624 -24.39 16.3086 +369 1 3.46858 4.77582 5.16944 -0.707582 -1.43422 0.766057 +370 1 3.76426 5.90532 4.89181 3.4437 -1.11423 -2.15979 +371 1 4.07073 4.92867 6.32743 11.4607 -11.4553 -4.32634 +372 1 3.67793 5.86643 6.05942 -4.35866 5.03724 -1.47182 +373 1 4.98792 5.51389 4.93524 -8.4187 -10.8933 -4.11136 +374 1 5.89023 6.01641 5.05179 11.0493 7.97987 -0.316877 +375 1 5.84913 5.21289 5.8287 7.09495 5.60009 -11.1489 +376 1 4.95887 5.92462 6.03819 -1.41241 -1.47294 -8.90972 +377 1 6.72618 5.24569 4.87739 -4.6501 10.2679 6.06598 +378 1 7.69701 6.07801 4.9728 1.45309 -5.4044 1.15049 +379 1 7.57443 5.25318 5.8022 -4.19719 -6.86637 2.5693 +380 1 6.75672 5.96198 5.84181 4.25859 -4.73277 0.116077 +381 1 0.149236 6.9327 4.88187 0.301354 -7.8021 16.5737 +382 1 1.06612 7.54377 5.19235 6.17987 -18.0682 -12.1896 +383 1 0.908663 6.67909 5.83913 1.89859 7.5565 8.00921 +384 1 8.3967 7.73373 5.73713 17.5958 -22.201 25.7152 +385 1 2.09262 6.53099 4.7967 1.84262 19.7267 -15.5304 +386 1 2.6809 7.4184 4.97144 1.84587 -3.02643 6.66108 +387 1 2.76451 6.5131 6.02372 26.4927 9.3308 7.09081 +388 1 1.89235 7.21971 6.07993 -5.61302 23.442 -46.1583 +389 1 3.56452 6.91614 5.29782 1.29026 -2.451 2.37678 +390 1 4.22056 7.80764 5.23329 -2.48711 -3.82055 1.83806 +391 1 4.29263 6.77471 6.12925 7.35038 5.5119 -5.7056 +392 1 2.85273 7.60961 6.07343 16.4578 1.27697 -7.39815 +393 1 4.81773 6.56695 4.97715 -1.40117 8.33727 3.10183 +394 1 5.78811 7.39325 5.43254 7.66799 3.74746 -17.7564 +395 1 5.91597 6.55237 6.07292 -10.3134 0.875812 3.19143 +396 1 5.1536 7.54901 6.2302 -8.62748 1.72241 13.4381 +397 1 6.84976 6.76387 5.09828 -3.19969 2.83039 -4.79256 +398 1 7.54117 7.72913 5.1763 -12.4453 -25.3207 -11.2598 +399 1 7.70324 6.72981 5.83369 -19.5261 3.79708 -10.3274 +400 1 6.77336 7.41197 5.93794 -9.93531 -0.946567 -12.2979 +401 1 8.22949 8.35705 6.76928 1.64244 -1.45449 1.77988 +402 1 0.72004 0.832942 6.72959 22.4465 -5.361 -6.29847 +403 1 0.883022 0.0931191 7.57241 -5.23405 -15.4407 -5.32038 +404 1 0.0468789 0.82113 7.48906 -16.6351 2.71194 14.972 +405 1 2.03902 8.21121 6.63645 7.11775 -8.1199 -7.72414 +406 1 2.8098 1.35985 6.35749 11.4457 2.58538 -2.95276 +407 1 2.39096 8.06897 7.6788 1.19633 7.68608 5.18448 +408 1 1.75996 0.580686 7.28683 6.89284 15.6237 4.36189 +409 1 3.24708 7.93738 6.98795 5.84043 19.9452 -24.3758 +410 1 4.23919 0.919929 6.46503 -1.07654 -9.91612 -5.08402 +411 1 3.90772 0.424381 7.41946 37.0812 -23.6824 -3.45202 +412 1 2.91871 0.505987 7.33506 -26.0302 7.74114 -11.0468 +413 1 4.92803 0.11282 7.09764 -8.28234 1.33652 -4.84063 +414 1 5.89475 1.0043 6.70526 7.29393 0.830325 27.9656 +415 1 5.8956 8.35718 7.44426 -3.02776 0.024361 13.8614 +416 1 4.71342 1.28665 7.29701 10.263 5.35948 11.5905 +417 1 6.8248 0.0574117 7.01961 11.7828 1.29904 -9.90689 +418 1 7.52034 1.04303 6.65362 -4.17639 -6.17679 3.43381 +419 1 7.73603 8.17986 7.79994 1.7859 4.36245 -17.9939 +420 1 7.13318 0.752429 7.78463 13.3591 3.5282 -5.71599 +421 1 8.39243 1.66394 6.67161 -0.134672 7.39125 4.10576 +422 1 0.854509 2.49412 6.65204 0.887161 -2.38052 0.586225 +423 1 1.18138 1.63924 7.31791 -41.6971 -18.352 25.0151 +424 1 0.0943458 2.334 7.66786 0.324396 10.57 -15.5201 +425 1 1.87867 1.74452 6.645 -1.95754 3.46436 -44.2754 +426 1 2.63684 2.47303 6.52845 -8.45632 -20.7999 4.28943 +427 1 2.51699 1.47554 7.37579 1.92109 3.65888 22.6814 +428 1 1.82876 2.39767 7.50566 14.4123 21.9409 0.136363 +429 1 3.78398 2.21463 6.57246 -2.68631 2.13236 -0.792617 +430 1 4.46308 3.07592 6.43555 -3.89191 7.33892 -9.13636 +431 1 3.59875 1.35397 7.20413 -9.98874 22.9069 2.08665 +432 1 3.19396 2.3577 7.56493 -2.6719 3.09783 -0.16421 +433 1 5.06299 2.1644 6.37533 -2.58633 -2.00836 2.79809 +434 1 5.67119 3.15784 6.34996 -0.566548 -6.83481 -5.10746 +435 1 5.66575 1.97666 7.57441 -14.7077 -20.3342 4.08546 +436 1 4.67442 2.64884 7.36908 -6.67424 -36.8328 0.644107 +437 1 6.68154 1.59605 7.24042 -18.9747 -1.14386 -19.0037 +438 1 7.52504 2.47849 6.70825 -1.30537 -8.16455 -5.2397 +439 1 7.60687 1.7083 7.61907 22.0172 -9.53549 -2.5479 +440 1 6.29708 2.66318 7.23348 12.1765 11.0009 -15.9537 +441 1 0.116615 3.32613 6.70965 -8.35482 -2.36763 -31.1169 +442 1 0.754871 4.30259 6.64315 -6.49201 3.33528 -9.76479 +443 1 0.673999 3.30917 7.54182 21.55 -11.008 11.6004 +444 1 8.2904 4.07274 7.4316 9.5379 25.3171 7.28976 +445 1 1.3832 3.4915 6.68441 -1.24784 -22.5622 2.29536 +446 1 2.09272 4.19927 6.89939 7.14914 10.3433 -0.646722 +447 1 2.38812 3.48925 7.75082 -1.53849 -4.15299 -0.56146 +448 1 0.98545 4.31304 7.66307 5.8465 7.34467 12.6645 +449 1 3.01955 3.30623 6.95327 13.2113 8.86686 7.49164 +450 1 4.09943 3.91395 7.09298 -2.48303 5.76893 1.33505 +451 1 4.01094 3.20608 7.89765 -2.70921 2.34384 1.12391 +452 1 3.37728 4.06259 7.97546 3.1883 6.31048 -16.9835 +453 1 4.95274 4.06193 6.44472 -50.262 -12.0969 -14.4258 +454 1 5.82886 4.19415 6.78586 51.8922 14.3443 21.8961 +455 1 5.38346 3.34165 7.34475 16.015 22.8896 8.36611 +456 1 5.08561 4.4601 7.63447 17.0994 -9.93497 -11.4722 +457 1 6.63523 3.51978 6.68288 11.156 -6.22589 -13.2585 +458 1 7.56324 4.26511 6.59456 -1.25309 2.63878 0.745103 +459 1 7.65852 3.28844 7.34661 -10.7372 -4.25374 3.64969 +460 1 6.81691 4.07739 7.53042 5.20496 31.087 -1.8792 +461 1 0.0305913 5.07954 6.63961 -13.4152 -0.334577 -15.0347 +462 1 0.755373 5.9128 6.63716 6.29428 -4.8245 9.83099 +463 1 0.228688 5.17338 7.63443 6.77209 -15.3569 2.77515 +464 1 0.0239769 6.1789 7.50959 5.71025 13.0173 8.45368 +465 1 1.62736 5.16876 6.26262 -1.95267 15.3222 16.2267 +466 1 2.58882 5.57631 6.81228 -21.3734 15.7914 -12.1527 +467 1 2.44828 4.86387 7.63128 0.635145 -14.9061 -0.714387 +468 1 1.59901 5.57209 7.51534 -11.1496 -3.28487 -5.03165 +469 1 3.34619 4.96263 7.08932 17.4571 -30.3367 -0.525226 +470 1 4.2543 5.71212 7.1129 9.72931 3.13017 -7.54215 +471 1 4.20945 4.90695 7.86069 -23.7666 -21.5851 -7.20856 +472 1 3.30097 5.87496 7.52978 -1.62077 18.6793 20.7743 +473 1 5.31869 5.1825 6.70313 -6.70115 -5.30598 20.424 +474 1 6.1285 5.9705 7.04356 -55.8752 -30.7828 -22.045 +475 1 6.19989 5.01385 7.64593 -24.2843 -27.8512 -0.0723503 +476 1 5.23737 5.71302 7.75618 7.88564 -2.82129 -5.95862 +477 1 6.57282 5.00818 6.64579 3.73801 7.56977 2.57742 +478 1 7.65968 6.07456 6.846 -10.6673 -6.72159 -16.2973 +479 1 7.41458 5.08419 7.34751 2.79575 -2.58892 1.26995 +480 1 6.72257 5.83109 7.80136 50.7146 16.6992 29.5346 +481 1 0.0723308 6.76891 6.47705 11.6111 8.10298 22.8191 +482 1 1.02933 7.74537 6.50218 -6.26193 -3.88943 1.15511 +483 1 0.947055 6.70337 7.58592 -5.51835 -14.0139 4.24362 +484 1 0.0848928 7.36532 7.45176 -1.87156 3.22591 1.0451 +485 1 1.56902 6.60766 6.76327 -14.013 -31.9293 15.0177 +486 1 2.40361 7.17234 6.95829 30.5527 12.991 8.35655 +487 1 2.29885 6.36291 7.58786 1.80834 5.53646 4.44151 +488 1 1.553 7.54602 7.43994 -8.27629 2.11355 -7.51923 +489 1 3.47111 6.73135 6.78593 -6.0772 1.66346 11.0677 +490 1 4.24975 7.49747 6.97664 2.8759 -9.15152 10.7243 +491 1 4.10179 6.68273 7.72108 -3.71491 1.8557 -11.1514 +492 1 3.18945 7.41445 7.81539 11.7129 -34.8369 22.2868 +493 1 5.09069 6.56162 6.92242 0.709322 1.72009 4.70344 +494 1 6.15914 7.53992 6.80488 -4.25562 -6.4834 8.29409 +495 1 6.17817 6.79535 7.72789 -19.4606 -0.130997 -26.8387 +496 1 5.10104 7.47088 7.65047 -2.76834 -2.47532 -11.4779 +497 1 6.74018 6.65599 6.74814 32.1985 25.9827 -14.7809 +498 1 7.41102 7.54832 6.72723 12.7336 -14.2037 26.5422 +499 1 7.28837 6.72521 7.66327 11.2322 2.95469 4.78999 +500 1 6.81386 7.67069 7.84231 -16.9841 5.08288 -4.95949 diff --git a/examples/mdi/dump.17Jun22.snapshot.driver.tcp.4 b/examples/mdi/dump.17Jun22.snapshot.driver.tcp.4 new file mode 100644 index 0000000000..db50370991 --- /dev/null +++ b/examples/mdi/dump.17Jun22.snapshot.driver.tcp.4 @@ -0,0 +1,2036 @@ +ITEM: TIMESTEP +0 +ITEM: NUMBER OF ATOMS +500 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +ITEM: ATOMS id type x y z f_2[1] f_2[2] f_2[3] +1 1 0 0 0 -1.06581e-14 -1.13243e-14 -1.09635e-14 +2 1 0.839798 0.839798 0 2.88658e-15 3.34455e-15 -9.76996e-15 +3 1 0.839798 0 0.839798 2.66454e-15 -9.65894e-15 4.45477e-15 +4 1 0 0.839798 0.839798 -1.15463e-14 2.88658e-15 3.44169e-15 +5 1 1.6796 0 0 -3.95517e-16 -1.06581e-14 -1.11022e-14 +6 1 2.51939 0.839798 0 -3.1225e-16 2.66454e-15 -9.76996e-15 +7 1 2.51939 0 0.839798 -7.97973e-16 -1.06581e-14 2.88658e-15 +8 1 1.6796 0.839798 0.839798 -4.3715e-16 3.10862e-15 3.1225e-15 +9 1 3.35919 0 0 1.30798e-14 -1.06581e-14 -1.06581e-14 +10 1 4.19899 0.839798 0 -2.24404e-14 2.66454e-15 -8.88178e-15 +11 1 4.19899 0 0.839798 -2.33424e-14 -8.88178e-15 2.55351e-15 +12 1 3.35919 0.839798 0.839798 1.37182e-14 3.10862e-15 4.23273e-15 +13 1 5.03879 0 0 3.19189e-16 -7.99361e-15 -7.10543e-15 +14 1 5.87859 0.839798 0 2.27665e-14 2.88658e-15 -7.99361e-15 +15 1 5.87859 0 0.839798 2.17673e-14 -7.99361e-15 2.77556e-15 +16 1 5.03879 0.839798 0.839798 -4.09395e-16 2.88658e-15 2.90046e-15 +17 1 6.71838 0 0 -3.21965e-15 -9.63118e-15 -1.01863e-14 +18 1 7.55818 0.839798 0 4.44089e-16 2.58127e-15 -9.10383e-15 +19 1 7.55818 0 0.839798 -4.44089e-16 -9.99201e-15 3.21965e-15 +20 1 6.71838 0.839798 0.839798 -2.94209e-15 2.90046e-15 4.02456e-15 +21 1 0 1.6796 0 -1.15463e-14 0 -1.04361e-14 +22 1 0.839798 2.51939 0 3.10862e-15 -9.71445e-17 -1.00198e-14 +23 1 0.839798 1.6796 0.839798 2.33147e-15 2.22045e-16 3.34455e-15 +24 1 0 2.51939 0.839798 -1.06581e-14 -7.21645e-16 2.9976e-15 +25 1 1.6796 1.6796 0 -4.23273e-16 6.93889e-18 -8.88178e-15 +26 1 2.51939 2.51939 0 -2.19963e-15 -1.77636e-15 -1.09079e-14 +27 1 2.51939 1.6796 0.839798 -1.2837e-15 9.08995e-16 2.88658e-15 +28 1 1.6796 2.51939 0.839798 3.53884e-16 -2.0331e-15 2.8727e-15 +29 1 3.35919 1.6796 0 1.351e-14 1.45717e-16 -7.99361e-15 +30 1 4.19899 2.51939 0 -2.32314e-14 -1.88738e-15 -9.99201e-15 +31 1 4.19899 1.6796 0.839798 -2.24404e-14 -2.08167e-16 3.33067e-15 +32 1 3.35919 2.51939 0.839798 1.45925e-14 -1.36002e-15 3.31679e-15 +33 1 5.03879 1.6796 0 2.28983e-16 1.94289e-16 -7.99361e-15 +34 1 5.87859 2.51939 0 2.13649e-14 -1.66533e-15 -8.21565e-15 +35 1 5.87859 1.6796 0.839798 1.98383e-14 1.17961e-15 3.10862e-15 +36 1 5.03879 2.51939 0.839798 3.40006e-16 -2.80331e-15 2.8727e-15 +37 1 6.71838 1.6796 0 -2.88658e-15 -2.63678e-16 -8.99281e-15 +38 1 7.55818 2.51939 0 1.33227e-15 -1.33227e-15 -9.99201e-15 +39 1 7.55818 1.6796 0.839798 -8.04912e-16 1.94289e-16 3.33067e-15 +40 1 6.71838 2.51939 0.839798 -3.10862e-15 -1.66533e-15 3.55271e-15 +41 1 0 3.35919 0 -1.06581e-14 1.31006e-14 -1.02141e-14 +42 1 0.839798 4.19899 0 2.66454e-15 -2.27873e-14 -9.34669e-15 +43 1 0.839798 3.35919 0.839798 2.33147e-15 1.43774e-14 4.01068e-15 +44 1 0 4.19899 0.839798 -9.76996e-15 -2.33147e-14 2.60902e-15 +45 1 1.6796 3.35919 0 -8.11851e-16 1.5099e-14 -1.02141e-14 +46 1 2.51939 4.19899 0 -1.89432e-15 -2.39808e-14 -7.54952e-15 +47 1 2.51939 3.35919 0.839798 -5.06539e-16 1.51268e-14 3.44169e-15 +48 1 1.6796 4.19899 0.839798 -4.16334e-16 -2.30926e-14 3.10862e-15 +49 1 3.35919 3.35919 0 1.26774e-14 1.46549e-14 -9.32587e-15 +50 1 4.19899 4.19899 0 -2.30302e-14 -2.4869e-14 -7.10543e-15 +51 1 4.19899 3.35919 0.839798 -2.21004e-14 1.13798e-14 2.77556e-15 +52 1 3.35919 4.19899 0.839798 1.18308e-14 -2.22045e-14 2.66454e-15 +53 1 5.03879 3.35919 0 6.93889e-17 1.13243e-14 -7.54952e-15 +54 1 5.87859 4.19899 0 2.21975e-14 -2.22045e-14 -6.43929e-15 +55 1 5.87859 3.35919 0.839798 2.14412e-14 1.27398e-14 2.77556e-15 +56 1 5.03879 4.19899 0.839798 -2.22045e-16 -2.13163e-14 2.72005e-15 +57 1 6.71838 3.35919 0 -3.38618e-15 1.34892e-14 -9.15934e-15 +58 1 7.55818 4.19899 0 0 -2.35367e-14 -7.32747e-15 +59 1 7.55818 3.35919 0.839798 1.11022e-16 1.39888e-14 3.10862e-15 +60 1 6.71838 4.19899 0.839798 -2.9976e-15 -2.31204e-14 2.34535e-15 +61 1 0 5.03879 0 -6.21725e-15 -2.22045e-16 -7.32747e-15 +62 1 0.839798 5.87859 0 2.44249e-15 2.22322e-14 -7.10543e-15 +63 1 0.839798 5.03879 0.839798 2.55351e-15 -1.66533e-16 2.61596e-15 +64 1 0 5.87859 0.839798 -7.10543e-15 2.15938e-14 3.10862e-15 +65 1 1.6796 5.03879 0 1.249e-16 4.44089e-16 -7.99361e-15 +66 1 2.51939 5.87859 0 -1.73472e-15 2.16008e-14 -7.99361e-15 +67 1 2.51939 5.03879 0.839798 -1.7833e-15 6.66134e-16 3.04617e-15 +68 1 1.6796 5.87859 0.839798 4.16334e-17 2.04697e-14 3.33067e-15 +69 1 3.35919 5.03879 0 1.08802e-14 0 -8.02136e-15 +70 1 4.19899 5.87859 0 -2.37727e-14 2.2253e-14 -6.21725e-15 +71 1 4.19899 5.03879 0.839798 -1.93734e-14 2.22045e-16 3.26822e-15 +72 1 3.35919 5.87859 0.839798 1.27537e-14 2.2593e-14 3.33067e-15 +73 1 5.03879 5.03879 0 1.94289e-16 6.66134e-16 -5.32907e-15 +74 1 5.87859 5.87859 0 2.20449e-14 2.1233e-14 -6.21725e-15 +75 1 5.87859 5.03879 0.839798 1.92277e-14 4.44089e-16 2.82413e-15 +76 1 5.03879 5.87859 0.839798 -6.93889e-18 2.00326e-14 3.33067e-15 +77 1 6.71838 5.03879 0 -2.27596e-15 -4.16334e-17 -8.24341e-15 +78 1 7.55818 5.87859 0 -8.88178e-16 2.33147e-14 -7.54952e-15 +79 1 7.55818 5.03879 0.839798 8.32667e-16 1.88738e-15 2.55351e-15 +80 1 6.71838 5.87859 0.839798 -3.16414e-15 2.25098e-14 3.1225e-15 +81 1 0 6.71838 0 -9.76996e-15 -3.77476e-15 -9.38138e-15 +82 1 0.839798 7.55818 0 2.22045e-15 1.67921e-15 -9.20097e-15 +83 1 0.839798 6.71838 0.839798 2.33147e-15 -2.83107e-15 3.58047e-15 +84 1 0 7.55818 0.839798 -7.99361e-15 -1.11022e-15 3.05311e-15 +85 1 1.6796 6.71838 0 1.38778e-16 -2.72005e-15 -8.99281e-15 +86 1 2.51939 7.55818 0 -2.69229e-15 1.55431e-15 -8.43769e-15 +87 1 2.51939 6.71838 0.839798 -7.91034e-16 -2.83801e-15 3.56659e-15 +88 1 1.6796 7.55818 0.839798 4.64906e-16 -5.55112e-17 3.10862e-15 +89 1 3.35919 6.71838 0 1.27398e-14 -2.10942e-15 -8.04912e-15 +90 1 4.19899 7.55818 0 -2.46053e-14 -2.22045e-16 -6.21725e-15 +91 1 4.19899 6.71838 0.839798 -2.40225e-14 -4.89886e-15 2.67841e-15 +92 1 3.35919 7.55818 0.839798 1.36349e-14 -5.55112e-17 2.66454e-15 +93 1 5.03879 6.71838 0 3.19189e-16 -3.71925e-15 -7.32747e-15 +94 1 5.87859 7.55818 0 2.2593e-14 0 -7.10543e-15 +95 1 5.87859 6.71838 0.839798 2.19269e-14 -2.62984e-15 2.45637e-15 +96 1 5.03879 7.55818 0.839798 -4.16334e-16 -8.32667e-17 2.05391e-15 +97 1 6.71838 6.71838 0 -2.60902e-15 -2.42861e-15 -7.99361e-15 +98 1 7.55818 7.55818 0 -4.44089e-16 -8.88178e-16 -8.88178e-15 +99 1 7.55818 6.71838 0.839798 -1.66533e-16 -2.22045e-15 2.55351e-15 +100 1 6.71838 7.55818 0.839798 -3.16414e-15 2.77556e-17 2.78944e-15 +101 1 0 0 1.6796 -1.15463e-14 -1.04361e-14 -8.88178e-16 +102 1 0.839798 0.839798 1.6796 2.44249e-15 2.56739e-15 6.66134e-16 +103 1 0.839798 0 2.51939 2.66454e-15 -9.65894e-15 -1.52656e-16 +104 1 0 0.839798 2.51939 -1.15463e-14 2.9976e-15 3.88578e-16 +105 1 1.6796 0 1.6796 2.15106e-16 -9.76996e-15 0 +106 1 2.51939 0.839798 1.6796 -1.71391e-15 2.66454e-15 3.88578e-16 +107 1 2.51939 0 2.51939 -1.74166e-15 -1.06581e-14 -1.60982e-15 +108 1 1.6796 0.839798 2.51939 2.63678e-16 3.10862e-15 -1.67227e-15 +109 1 3.35919 0 1.6796 1.42039e-14 -8.88178e-15 8.88178e-16 +110 1 4.19899 0.839798 1.6796 -2.18159e-14 2.44249e-15 -6.10623e-16 +111 1 4.19899 0 2.51939 -2.31759e-14 -9.76996e-15 -1.66533e-15 +112 1 3.35919 0.839798 2.51939 1.4419e-14 2.88658e-15 -1.90126e-15 +113 1 5.03879 0 1.6796 9.08995e-16 -9.76996e-15 8.88178e-16 +114 1 5.87859 0.839798 1.6796 2.02685e-14 2.44249e-15 1.02696e-15 +115 1 5.87859 0 2.51939 2.0213e-14 -8.88178e-15 -1.27676e-15 +116 1 5.03879 0.839798 2.51939 2.91434e-16 3.10862e-15 -1.45023e-15 +117 1 6.71838 0 1.6796 -2.30371e-15 -9.65894e-15 -9.02056e-17 +118 1 7.55818 0.839798 1.6796 3.747e-16 2.16493e-15 1.04083e-16 +119 1 7.55818 0 2.51939 1.33227e-15 -9.76996e-15 -1.9984e-15 +120 1 6.71838 0.839798 2.51939 -3.10862e-15 2.90046e-15 -2.10942e-15 +121 1 0 1.6796 1.6796 -1.28786e-14 8.88178e-16 6.66134e-16 +122 1 0.839798 2.51939 1.6796 2.33147e-15 -1.43635e-15 1.11022e-16 +123 1 0.839798 1.6796 2.51939 2.66454e-15 7.35523e-16 -1.30451e-15 +124 1 0 2.51939 2.51939 -9.76996e-15 -1.249e-15 -1.4988e-15 +125 1 1.6796 1.6796 1.6796 2.22045e-16 -1.67921e-15 5.96745e-16 +126 1 2.51939 2.51939 1.6796 -8.95117e-16 -2.39392e-15 -1.3739e-15 +127 1 2.51939 1.6796 2.51939 -9.22873e-16 1.38778e-17 -1.17267e-15 +128 1 1.6796 2.51939 2.51939 1.38778e-16 -1.4988e-15 -2.498e-15 +129 1 3.35919 1.6796 1.6796 1.44329e-14 -1.58207e-15 5.27356e-16 +130 1 4.19899 2.51939 1.6796 -2.17534e-14 -1.89432e-15 -4.85723e-16 +131 1 4.19899 1.6796 2.51939 -2.2024e-14 4.64906e-16 -2.11636e-15 +132 1 3.35919 2.51939 2.51939 1.47937e-14 -1.55431e-15 -2.52576e-15 +133 1 5.03879 1.6796 1.6796 6.38378e-16 -4.78784e-16 8.46545e-16 +134 1 5.87859 2.51939 1.6796 2.05322e-14 -1.4086e-15 2.28983e-16 +135 1 5.87859 1.6796 2.51939 2.02546e-14 -2.56739e-16 -2.07473e-15 +136 1 5.03879 2.51939 2.51939 5.82867e-16 -2.16493e-15 -2.498e-15 +137 1 6.71838 1.6796 1.6796 -2.16493e-15 -9.4369e-16 5.55112e-17 +138 1 7.55818 2.51939 1.6796 -4.44089e-16 -1.11022e-15 -2.77556e-17 +139 1 7.55818 1.6796 2.51939 4.44089e-16 -6.93889e-18 -2.22045e-15 +140 1 6.71838 2.51939 2.51939 -3.27516e-15 -1.76248e-15 -2.55351e-15 +141 1 0 3.35919 1.6796 -1.11022e-14 1.39888e-14 -2.22045e-16 +142 1 0.839798 4.19899 1.6796 2.55351e-15 -2.46053e-14 -7.77156e-16 +143 1 0.839798 3.35919 2.51939 2.88658e-15 1.46688e-14 -1.47105e-15 +144 1 0 4.19899 2.51939 -7.99361e-15 -2.26485e-14 -1.33227e-15 +145 1 1.6796 3.35919 1.6796 2.08167e-16 1.37251e-14 5.41234e-16 +146 1 2.51939 4.19899 1.6796 -1.9082e-15 -2.30926e-14 -1.55431e-15 +147 1 2.51939 3.35919 2.51939 -1.04777e-15 1.5099e-14 -1.77636e-15 +148 1 1.6796 4.19899 2.51939 -2.01228e-16 -2.22045e-14 -2.27596e-15 +149 1 3.35919 3.35919 1.6796 1.39194e-14 1.31006e-14 3.46945e-16 +150 1 4.19899 4.19899 1.6796 -2.1802e-14 -2.22045e-14 -4.44089e-16 +151 1 4.19899 3.35919 2.51939 -2.31759e-14 1.11022e-14 -2.44249e-15 +152 1 3.35919 4.19899 2.51939 1.19696e-14 -2.30926e-14 -1.38778e-15 +153 1 5.03879 3.35919 1.6796 -6.93889e-18 1.12688e-14 1.38778e-16 +154 1 5.87859 4.19899 1.6796 2.09208e-14 -2.22045e-14 -4.44089e-16 +155 1 5.87859 3.35919 2.51939 2.10595e-14 1.06581e-14 -1.9984e-15 +156 1 5.03879 4.19899 2.51939 -2.22045e-16 -2.13163e-14 -2.05391e-15 +157 1 6.71838 3.35919 1.6796 -2.96291e-15 1.29619e-14 -1.11716e-15 +158 1 7.55818 4.19899 1.6796 1.11022e-15 -2.30926e-14 -1.52656e-15 +159 1 7.55818 3.35919 2.51939 4.44089e-16 1.40998e-14 -8.88178e-16 +160 1 6.71838 4.19899 2.51939 -2.83107e-15 -2.29539e-14 -1.73472e-15 +161 1 0 5.03879 1.6796 -7.99361e-15 1.11022e-15 -4.44089e-16 +162 1 0.839798 5.87859 1.6796 2.44249e-15 1.9991e-14 2.77556e-16 +163 1 0.839798 5.03879 2.51939 2.88658e-15 6.80012e-16 -1.66533e-16 +164 1 0 5.87859 2.51939 -7.99361e-15 2.1011e-14 -1.77636e-15 +165 1 1.6796 5.03879 1.6796 4.71845e-16 -3.33067e-16 -1.11022e-16 +166 1 2.51939 5.87859 1.6796 -8.88178e-16 2.06501e-14 8.04912e-16 +167 1 2.51939 5.03879 2.51939 -2.06085e-15 -2.22045e-16 -1.08941e-15 +168 1 1.6796 5.87859 2.51939 2.63678e-16 2.05669e-14 -2.28983e-15 +169 1 3.35919 5.03879 1.6796 1.12202e-14 -1.11022e-15 6.93889e-16 +170 1 4.19899 5.87859 1.6796 -2.19824e-14 2.13163e-14 6.52256e-16 +171 1 4.19899 5.03879 2.51939 -1.94983e-14 -2.22045e-16 -1.7486e-15 +172 1 3.35919 5.87859 2.51939 1.26982e-14 2.15383e-14 -1.8735e-15 +173 1 5.03879 5.03879 1.6796 6.245e-17 -9.99201e-16 6.38378e-16 +174 1 5.87859 5.87859 1.6796 2.06501e-14 2.06501e-14 3.33067e-16 +175 1 5.87859 5.03879 2.51939 1.84575e-14 1.11022e-15 -8.04912e-16 +176 1 5.03879 5.87859 2.51939 -2.22045e-16 1.88322e-14 -2.51188e-15 +177 1 6.71838 5.03879 1.6796 -3.22659e-15 -1.26288e-15 -2.22045e-16 +178 1 7.55818 5.87859 1.6796 2.22045e-16 2.19824e-14 8.60423e-16 +179 1 7.55818 5.03879 2.51939 -8.88178e-16 1.11022e-16 -1.77636e-15 +180 1 6.71838 5.87859 2.51939 -2.9976e-15 2.17326e-14 -2.78944e-15 +181 1 0 6.71838 1.6796 -9.76996e-15 -2.88658e-15 0 +182 1 0.839798 7.55818 1.6796 2.10942e-15 1.17961e-15 9.15934e-16 +183 1 0.839798 6.71838 2.51939 2.66454e-15 -3.10862e-15 -1.19349e-15 +184 1 0 7.55818 2.51939 -1.06581e-14 8.88178e-16 -2.77556e-15 +185 1 1.6796 6.71838 1.6796 1.38778e-16 -2.31759e-15 -3.19189e-16 +186 1 2.51939 7.55818 1.6796 -1.1241e-15 8.8124e-16 -1.249e-16 +187 1 2.51939 6.71838 2.51939 -1.19349e-15 -3.10862e-15 -2.96985e-15 +188 1 1.6796 7.55818 2.51939 2.77556e-17 2.22045e-16 -1.9984e-15 +189 1 3.35919 6.71838 1.6796 1.29757e-14 -2.02616e-15 -5.06539e-16 +190 1 4.19899 7.55818 1.6796 -2.29122e-14 1.06859e-15 -2.91434e-16 +191 1 4.19899 6.71838 2.51939 -2.36616e-14 -4.60743e-15 -2.9976e-15 +192 1 3.35919 7.55818 2.51939 1.28508e-14 2.22045e-16 -2.22045e-15 +193 1 5.03879 6.71838 1.6796 1.31839e-16 -2.53964e-15 -6.52256e-16 +194 1 5.87859 7.55818 1.6796 2.15661e-14 7.63278e-16 -9.71445e-16 +195 1 5.87859 6.71838 2.51939 2.18089e-14 -3.88578e-15 -2.63678e-15 +196 1 5.03879 7.55818 2.51939 0 -6.66134e-16 -1.9984e-15 +197 1 6.71838 6.71838 1.6796 -2.24126e-15 -2.59515e-15 -1.0339e-15 +198 1 7.55818 7.55818 1.6796 4.44089e-16 0 -8.32667e-17 +199 1 7.55818 6.71838 2.51939 -8.88178e-16 -2.27596e-15 -1.77636e-15 +200 1 6.71838 7.55818 2.51939 -3.21965e-15 -9.71445e-17 -2.35922e-15 +201 1 0 0 3.35919 -1.06581e-14 -1.04361e-14 1.35447e-14 +202 1 0.839798 0.839798 3.35919 2.66454e-15 2.67841e-15 1.50435e-14 +203 1 0.839798 0 4.19899 2.88658e-15 -9.65894e-15 -2.24473e-14 +204 1 0 0.839798 4.19899 -7.99361e-15 2.88658e-15 -2.26485e-14 +205 1 1.6796 0 3.35919 2.15106e-16 -8.88178e-15 1.42109e-14 +206 1 2.51939 0.839798 3.35919 -1.83881e-15 2.77556e-15 1.55431e-14 +207 1 2.51939 0 4.19899 -1.76942e-15 -8.88178e-15 -2.35367e-14 +208 1 1.6796 0.839798 4.19899 -3.53884e-16 2.66454e-15 -2.19824e-14 +209 1 3.35919 0 3.35919 1.37598e-14 -7.99361e-15 1.46549e-14 +210 1 4.19899 0.839798 3.35919 -2.30232e-14 2.66454e-15 1.19071e-14 +211 1 4.19899 0 4.19899 -2.28637e-14 -7.10543e-15 -2.35367e-14 +212 1 3.35919 0.839798 4.19899 1.17892e-14 2.66454e-15 -2.28706e-14 +213 1 5.03879 0 3.35919 2.08167e-17 -7.99361e-15 1.08802e-14 +214 1 5.87859 0.839798 3.35919 2.2489e-14 2.55351e-15 1.36002e-14 +215 1 5.87859 0 4.19899 2.18922e-14 -5.32907e-15 -2.28706e-14 +216 1 5.03879 0.839798 4.19899 -1.25594e-15 2.66454e-15 -2.2024e-14 +217 1 6.71838 0 3.35919 -2.47025e-15 -8.77076e-15 1.29619e-14 +218 1 7.55818 0.839798 3.35919 -1.11022e-15 2.60902e-15 1.4766e-14 +219 1 7.55818 0 4.19899 -4.44089e-16 -6.66134e-15 -2.39808e-14 +220 1 6.71838 0.839798 4.19899 -2.60902e-15 2.90046e-15 -2.30371e-14 +221 1 0 1.6796 3.35919 -1.11022e-14 -2.22045e-16 1.44329e-14 +222 1 0.839798 2.51939 3.35919 2.77556e-15 -5.68989e-16 1.53766e-14 +223 1 0.839798 1.6796 4.19899 2.66454e-15 1.52656e-16 -2.39253e-14 +224 1 0 2.51939 4.19899 -8.88178e-15 -1.63758e-15 -2.37588e-14 +225 1 1.6796 1.6796 3.35919 2.22045e-16 -7.91034e-16 1.5779e-14 +226 1 2.51939 2.51939 3.35919 -1.4086e-15 -9.15934e-16 1.38917e-14 +227 1 2.51939 1.6796 4.19899 -1.72778e-15 2.84495e-16 -2.30926e-14 +228 1 1.6796 2.51939 4.19899 -7.28584e-16 -8.88178e-16 -2.2482e-14 +229 1 3.35919 1.6796 3.35919 1.39888e-14 -2.77556e-17 1.57235e-14 +230 1 4.19899 2.51939 3.35919 -2.32939e-14 -1.98452e-15 1.25663e-14 +231 1 4.19899 1.6796 4.19899 -2.16285e-14 -2.22045e-16 -2.22045e-14 +232 1 3.35919 2.51939 4.19899 1.21222e-14 -1.60982e-15 -2.33147e-14 +233 1 5.03879 1.6796 3.35919 -2.498e-16 -9.22873e-16 1.29757e-14 +234 1 5.87859 2.51939 3.35919 2.13649e-14 -9.71445e-17 1.28855e-14 +235 1 5.87859 1.6796 4.19899 2.10457e-14 -1.0339e-15 -2.22045e-14 +236 1 5.03879 2.51939 4.19899 -5.13478e-16 -2.05391e-15 -2.16771e-14 +237 1 6.71838 1.6796 3.35919 -3.19883e-15 -4.996e-16 1.39264e-14 +238 1 7.55818 2.51939 3.35919 -4.44089e-16 -2.22045e-15 1.29896e-14 +239 1 7.55818 1.6796 4.19899 6.66134e-16 -5.06539e-16 -2.4869e-14 +240 1 6.71838 2.51939 4.19899 -2.498e-15 -1.90126e-15 -2.40918e-14 +241 1 0 3.35919 3.35919 -1.11022e-14 1.35447e-14 1.33227e-14 +242 1 0.839798 4.19899 3.35919 2.77556e-15 -2.37171e-14 1.12133e-14 +243 1 0.839798 3.35919 4.19899 2.66454e-15 1.23929e-14 -2.45498e-14 +244 1 0 4.19899 4.19899 -7.10543e-15 -2.35367e-14 -2.29816e-14 +245 1 1.6796 3.35919 3.35919 2.08167e-16 1.33782e-14 1.51545e-14 +246 1 2.51939 4.19899 3.35919 -1.46411e-15 -2.13163e-14 1.06581e-14 +247 1 2.51939 3.35919 4.19899 -2.2829e-15 1.26565e-14 -2.33147e-14 +248 1 1.6796 4.19899 4.19899 -2.84495e-16 -2.30926e-14 -2.17604e-14 +249 1 3.35919 3.35919 3.35919 1.27814e-14 1.27121e-14 1.41553e-14 +250 1 4.19899 4.19899 3.35919 -2.30857e-14 -2.22045e-14 8.88178e-15 +251 1 4.19899 3.35919 4.19899 -2.29677e-14 9.32587e-15 -2.44249e-14 +252 1 3.35919 4.19899 4.19899 9.80466e-15 -2.30926e-14 -2.24265e-14 +253 1 5.03879 3.35919 3.35919 -2.28983e-16 1.00475e-14 1.12133e-14 +254 1 5.87859 4.19899 3.35919 2.19824e-14 -2.30926e-14 9.32587e-15 +255 1 5.87859 3.35919 4.19899 2.17881e-14 1.06581e-14 -2.53131e-14 +256 1 5.03879 4.19899 4.19899 -3.53884e-16 -2.04281e-14 -2.10942e-14 +257 1 6.71838 3.35919 3.35919 -3.1225e-15 1.29619e-14 1.27814e-14 +258 1 7.55818 4.19899 3.35919 6.66134e-16 -2.4647e-14 9.76996e-15 +259 1 7.55818 3.35919 4.19899 4.44089e-16 1.05749e-14 -2.53131e-14 +260 1 6.71838 4.19899 4.19899 -3.16414e-15 -2.29816e-14 -2.33424e-14 +261 1 0 5.03879 3.35919 -7.99361e-15 4.44089e-16 1.15463e-14 +262 1 0.839798 5.87859 3.35919 2.44249e-15 2.17673e-14 1.32672e-14 +263 1 0.839798 5.03879 4.19899 2.88658e-15 1.94289e-16 -2.1233e-14 +264 1 0 5.87859 4.19899 -6.21725e-15 2.16216e-14 -2.37588e-14 +265 1 1.6796 5.03879 3.35919 2.498e-16 -5.55112e-16 1.17684e-14 +266 1 2.51939 5.87859 3.35919 -1.11022e-15 2.13163e-14 1.34337e-14 +267 1 2.51939 5.03879 4.19899 -2.14412e-15 8.88178e-16 -2.12053e-14 +268 1 1.6796 5.87859 4.19899 2.498e-16 2.09971e-14 -2.13163e-14 +269 1 3.35919 5.03879 3.35919 1.09981e-14 -4.44089e-16 1.1241e-14 +270 1 4.19899 5.87859 3.35919 -2.33147e-14 2.19824e-14 1.00406e-14 +271 1 4.19899 5.03879 4.19899 -2.07542e-14 -4.44089e-16 -2.11775e-14 +272 1 3.35919 5.87859 4.19899 1.04916e-14 2.26069e-14 -2.22045e-14 +273 1 5.03879 5.03879 3.35919 6.245e-17 -3.33067e-16 8.27116e-15 +274 1 5.87859 5.87859 3.35919 2.19824e-14 2.10942e-14 9.47159e-15 +275 1 5.87859 5.03879 4.19899 1.91305e-14 4.44089e-16 -2.11775e-14 +276 1 5.03879 5.87859 4.19899 3.05311e-16 1.99285e-14 -2.13163e-14 +277 1 6.71838 5.03879 3.35919 -2.26208e-15 2.91434e-16 1.09773e-14 +278 1 7.55818 5.87859 3.35919 2.22045e-16 2.33147e-14 9.88098e-15 +279 1 7.55818 5.03879 4.19899 -4.44089e-16 5.55112e-16 -2.28706e-14 +280 1 6.71838 5.87859 4.19899 -3.10862e-15 2.27873e-14 -2.21212e-14 +281 1 0 6.71838 3.35919 -9.76996e-15 -3.77476e-15 1.31006e-14 +282 1 0.839798 7.55818 3.35919 2.22045e-15 3.46945e-16 1.46827e-14 +283 1 0.839798 6.71838 4.19899 2.66454e-15 -2.498e-15 -2.40086e-14 +284 1 0 7.55818 4.19899 -8.88178e-15 -2.22045e-16 -2.48135e-14 +285 1 1.6796 6.71838 3.35919 1.38778e-16 -2.25514e-15 1.30868e-14 +286 1 2.51939 7.55818 3.35919 -2.23432e-15 7.21645e-16 1.35447e-14 +287 1 2.51939 6.71838 4.19899 -1.64452e-15 -2.66454e-15 -2.40918e-14 +288 1 1.6796 7.55818 4.19899 -3.05311e-16 2.22045e-16 -2.39808e-14 +289 1 3.35919 6.71838 3.35919 1.25316e-14 -2.85189e-15 1.33574e-14 +290 1 4.19899 7.55818 3.35919 -2.53617e-14 -5.55112e-17 1.02141e-14 +291 1 4.19899 6.71838 4.19899 -2.41057e-14 -2.94209e-15 -2.32314e-14 +292 1 3.35919 7.55818 4.19899 1.14075e-14 2.22045e-16 -2.37588e-14 +293 1 5.03879 6.71838 3.35919 -3.1225e-16 -3.36536e-15 9.20097e-15 +294 1 5.87859 7.55818 3.35919 2.31273e-14 1.11022e-16 1.01585e-14 +295 1 5.87859 6.71838 4.19899 2.2711e-14 -3.4972e-15 -2.40918e-14 +296 1 5.03879 7.55818 4.19899 -8.32667e-17 6.66134e-16 -2.24265e-14 +297 1 6.71838 6.71838 3.35919 -3.13638e-15 -2.97679e-15 1.16573e-14 +298 1 7.55818 7.55818 3.35919 -4.44089e-16 -4.44089e-16 1.2268e-14 +299 1 7.55818 6.71838 4.19899 -4.44089e-16 -3.16414e-15 -2.62013e-14 +300 1 6.71838 7.55818 4.19899 -1.9984e-15 -1.52656e-16 -2.6118e-14 +301 1 0 0 5.03879 -7.99361e-15 -6.66134e-15 2.22045e-16 +302 1 0.839798 0.839798 5.03879 2.33147e-15 2.45637e-15 1.11022e-16 +303 1 0.839798 0 5.87859 2.44249e-15 -6.10623e-15 2.20934e-14 +304 1 0 0.839798 5.87859 -7.99361e-15 2.35922e-15 2.17604e-14 +305 1 1.6796 0 5.03879 -3.33067e-16 -8.88178e-15 0 +306 1 2.51939 0.839798 5.03879 -1.30451e-15 2.44249e-15 1.16573e-15 +307 1 2.51939 0 5.87859 -1.73472e-15 -7.10543e-15 2.13163e-14 +308 1 1.6796 0.839798 5.87859 2.77556e-17 3.33067e-15 2.08791e-14 +309 1 3.35919 0 5.03879 1.10051e-14 -7.99361e-15 6.66134e-16 +310 1 4.19899 0.839798 5.03879 -2.01922e-14 2.55351e-15 3.33067e-16 +311 1 4.19899 0 5.87859 -2.36061e-14 -4.44089e-15 2.226e-14 +312 1 3.35919 0.839798 5.87859 1.25663e-14 2.88658e-15 2.29261e-14 +313 1 5.03879 0 5.03879 -2.63678e-16 -6.21725e-15 1.11022e-15 +314 1 5.87859 0.839798 5.03879 1.90889e-14 2.66454e-15 1.22125e-15 +315 1 5.87859 0 5.87859 2.1913e-14 -4.44089e-15 2.19269e-14 +316 1 5.03879 0.839798 5.87859 -2.28983e-16 3.10862e-15 2.01297e-14 +317 1 6.71838 0 5.03879 -3.21965e-15 -4.38538e-15 7.49401e-16 +318 1 7.55818 0.839798 5.03879 -4.44089e-16 2.19269e-15 2.44249e-15 +319 1 7.55818 0 5.87859 -4.44089e-16 -7.32747e-15 2.37588e-14 +320 1 6.71838 0.839798 5.87859 -2.55351e-15 2.67841e-15 2.34257e-14 +321 1 0 1.6796 5.03879 -7.10543e-15 -6.66134e-16 8.88178e-16 +322 1 0.839798 2.51939 5.03879 2.44249e-15 -1.19349e-15 -2.77556e-17 +323 1 0.839798 1.6796 5.87859 2.66454e-15 -7.07767e-16 2.14273e-14 +324 1 0 2.51939 5.87859 -7.99361e-15 -1.66533e-15 2.14828e-14 +325 1 1.6796 1.6796 5.03879 1.94289e-16 -5.48173e-16 4.44089e-16 +326 1 2.51939 2.51939 5.03879 -1.02696e-15 -1.26288e-15 -7.56339e-16 +327 1 2.51939 1.6796 5.87859 -8.88178e-16 9.71445e-17 2.10942e-14 +328 1 1.6796 2.51939 5.87859 1.38778e-17 -6.10623e-16 2.04003e-14 +329 1 3.35919 1.6796 5.03879 1.18031e-14 2.42861e-16 -2.22045e-16 +330 1 4.19899 2.51939 5.03879 -2.02546e-14 -2.13024e-15 3.53884e-16 +331 1 4.19899 1.6796 5.87859 -2.17604e-14 -1.80411e-16 2.13163e-14 +332 1 3.35919 2.51939 5.87859 1.22541e-14 -7.21645e-16 2.11497e-14 +333 1 5.03879 1.6796 5.03879 8.95117e-16 -5.75928e-16 8.88178e-16 +334 1 5.87859 2.51939 5.03879 1.87558e-14 -8.04912e-16 1.24206e-15 +335 1 5.87859 1.6796 5.87859 2.08722e-14 -3.46945e-16 2.10942e-14 +336 1 5.03879 2.51939 5.87859 1.20737e-15 -3.88578e-16 1.87628e-14 +337 1 6.71838 1.6796 5.03879 -3.00454e-15 -8.95117e-16 -4.16334e-17 +338 1 7.55818 2.51939 5.03879 -8.88178e-16 -1.77636e-15 9.4369e-16 +339 1 7.55818 1.6796 5.87859 2.22045e-16 9.4369e-16 2.22045e-14 +340 1 6.71838 2.51939 5.87859 -2.94209e-15 -1.17961e-15 2.15106e-14 +341 1 0 3.35919 5.03879 -7.99361e-15 1.06581e-14 0 +342 1 0.839798 4.19899 5.03879 2.66454e-15 -2.28359e-14 -1.38778e-16 +343 1 0.839798 3.35919 5.87859 2.44249e-15 1.19904e-14 2.33008e-14 +344 1 0 4.19899 5.87859 -6.21725e-15 -2.33147e-14 2.226e-14 +345 1 1.6796 3.35919 5.03879 2.08167e-16 1.11577e-14 4.996e-16 +346 1 2.51939 4.19899 5.03879 -1.74166e-15 -2.13163e-14 -4.44089e-16 +347 1 2.51939 3.35919 5.87859 -1.19349e-15 1.15463e-14 2.17604e-14 +348 1 1.6796 4.19899 5.87859 -5.55112e-17 -2.04281e-14 2.13718e-14 +349 1 3.35919 3.35919 5.03879 1.08177e-14 1.04916e-14 -2.77556e-16 +350 1 4.19899 4.19899 5.03879 -2.10457e-14 -2.13163e-14 -1.9984e-15 +351 1 4.19899 3.35919 5.87859 -2.33286e-14 9.76996e-15 2.15383e-14 +352 1 3.35919 4.19899 5.87859 1.03251e-14 -2.13163e-14 2.30926e-14 +353 1 5.03879 3.35919 5.03879 6.38378e-16 6.71685e-15 -1.66533e-16 +354 1 5.87859 4.19899 5.03879 1.88877e-14 -2.13163e-14 -4.44089e-16 +355 1 5.87859 3.35919 5.87859 2.20379e-14 9.99201e-15 2.24265e-14 +356 1 5.03879 4.19899 5.87859 9.71445e-17 -1.95399e-14 2.00395e-14 +357 1 6.71838 3.35919 5.03879 -2.92821e-15 9.64506e-15 -1.42941e-15 +358 1 7.55818 4.19899 5.03879 -2.22045e-16 -2.26485e-14 8.88178e-16 +359 1 7.55818 3.35919 5.87859 0 1.21014e-14 2.33147e-14 +360 1 6.71838 4.19899 5.87859 -3.4972e-15 -2.11775e-14 2.40086e-14 +361 1 0 5.03879 5.03879 -4.44089e-15 1.11022e-15 4.44089e-16 +362 1 0.839798 5.87859 5.03879 2.10942e-15 1.80897e-14 3.33067e-16 +363 1 0.839798 5.03879 5.87859 2.88658e-15 1.38778e-17 1.93734e-14 +364 1 0 5.87859 5.87859 -5.32907e-15 2.22322e-14 2.29261e-14 +365 1 1.6796 5.03879 5.03879 -2.08167e-16 -3.33067e-16 -4.996e-16 +366 1 2.51939 5.87859 5.03879 -1.56819e-15 1.85754e-14 2.44249e-15 +367 1 2.51939 5.03879 5.87859 -1.56819e-15 2.22045e-16 2.07334e-14 +368 1 1.6796 5.87859 5.87859 3.46945e-16 2.06085e-14 2.06155e-14 +369 1 3.35919 5.03879 5.03879 8.10463e-15 -2.22045e-16 6.66134e-16 +370 1 4.19899 5.87859 5.03879 -2.05252e-14 1.93803e-14 8.88178e-16 +371 1 4.19899 5.03879 5.87859 -2.11428e-14 1.11022e-15 1.98105e-14 +372 1 3.35919 5.87859 5.87859 1.05194e-14 2.16355e-14 2.19477e-14 +373 1 5.03879 5.03879 5.03879 -1.38778e-17 0 2.77556e-17 +374 1 5.87859 5.87859 5.03879 1.91513e-14 1.84922e-14 1.77636e-15 +375 1 5.87859 5.03879 5.87859 1.93248e-14 8.88178e-16 1.91375e-14 +376 1 5.03879 5.87859 5.87859 3.46945e-16 1.88322e-14 1.95607e-14 +377 1 6.71838 5.03879 5.03879 -3.06699e-15 6.93889e-17 -4.57967e-16 +378 1 7.55818 5.87859 5.03879 0 2.04281e-14 -4.44089e-16 +379 1 7.55818 5.03879 5.87859 4.44089e-16 5.82867e-16 2.19824e-14 +380 1 6.71838 5.87859 5.87859 -3.55271e-15 2.33841e-14 2.40086e-14 +381 1 0 6.71838 5.03879 -7.54952e-15 -4.44089e-15 8.88178e-16 +382 1 0.839798 7.55818 5.03879 2.33147e-15 -4.85723e-16 2.41474e-15 +383 1 0.839798 6.71838 5.87859 3.10862e-15 -1.33227e-15 2.21906e-14 +384 1 0 7.55818 5.87859 -6.21725e-15 0 2.35922e-14 +385 1 1.6796 6.71838 5.03879 6.45317e-16 -3.44863e-15 -2.63678e-16 +386 1 2.51939 7.55818 5.03879 -1.96371e-15 -5.55112e-17 5.55112e-16 +387 1 2.51939 6.71838 5.87859 -1.55431e-15 -1.66533e-15 2.21767e-14 +388 1 1.6796 7.55818 5.87859 3.46945e-16 6.66134e-16 2.19824e-14 +389 1 3.35919 6.71838 5.03879 1.04777e-14 -3.17107e-15 8.46545e-16 +390 1 4.19899 7.55818 5.03879 -2.16979e-14 1.66533e-16 2.10942e-15 +391 1 4.19899 6.71838 5.87859 -2.39531e-14 -2.88658e-15 2.22045e-14 +392 1 3.35919 7.55818 5.87859 1.07414e-14 2.22045e-16 2.33147e-14 +393 1 5.03879 6.71838 5.03879 3.67761e-16 -3.74006e-15 4.02456e-16 +394 1 5.87859 7.55818 5.03879 2.08999e-14 2.77556e-16 2.22045e-16 +395 1 5.87859 6.71838 5.87859 2.30649e-14 -1.94289e-15 2.37588e-14 +396 1 5.03879 7.55818 5.87859 1.38778e-16 2.22045e-16 2.13163e-14 +397 1 6.71838 6.71838 5.03879 -3.53884e-15 -3.51802e-15 -8.32667e-17 +398 1 7.55818 7.55818 5.03879 0 0 3.33067e-16 +399 1 7.55818 6.71838 5.87859 0 -3.55271e-15 2.44249e-14 +400 1 6.71838 7.55818 5.87859 -3.44169e-15 9.99201e-16 2.4647e-14 +401 1 0 0 6.71838 -9.76996e-15 -9.54792e-15 -3.77476e-15 +402 1 0.839798 0.839798 6.71838 2.66454e-15 2.67841e-15 -2.72005e-15 +403 1 0.839798 0 7.55818 2.55351e-15 -7.92422e-15 -7.21645e-16 +404 1 0 0.839798 7.55818 -7.99361e-15 2.56739e-15 -4.44089e-16 +405 1 1.6796 0 6.71838 2.498e-16 -8.88178e-15 -3.55271e-15 +406 1 2.51939 0.839798 6.71838 -1.8735e-15 2.77556e-15 -3.60822e-15 +407 1 2.51939 0 7.55818 -2.30371e-15 -7.10543e-15 6.66134e-16 +408 1 1.6796 0.839798 7.55818 1.16573e-15 2.55351e-15 3.33067e-16 +409 1 3.35919 0 6.71838 1.26704e-14 -7.10543e-15 -3.10862e-15 +410 1 4.19899 0.839798 6.71838 -2.40641e-14 2.44249e-15 -4.69069e-15 +411 1 4.19899 0 7.55818 -2.46123e-14 -7.10543e-15 -6.66134e-16 +412 1 3.35919 0.839798 7.55818 1.24484e-14 2.55351e-15 1.33227e-15 +413 1 5.03879 0 6.71838 2.63678e-16 -6.21725e-15 -3.9968e-15 +414 1 5.87859 0.839798 6.71838 2.22253e-14 2.55351e-15 -2.38698e-15 +415 1 5.87859 0 7.55818 2.26069e-14 -6.21725e-15 -6.66134e-16 +416 1 5.03879 0.839798 7.55818 -1.66533e-16 2.77556e-15 1.66533e-16 +417 1 6.71838 0 6.71838 -2.498e-15 -6.99441e-15 -4.16334e-15 +418 1 7.55818 0.839798 6.71838 -1.16573e-15 2.60902e-15 -3.10862e-15 +419 1 7.55818 0 7.55818 -4.44089e-16 -8.65974e-15 -8.88178e-16 +420 1 6.71838 0.839798 7.55818 -3.16414e-15 2.45637e-15 6.66134e-16 +421 1 0 1.6796 6.71838 -9.32587e-15 -4.44089e-16 -3.33067e-15 +422 1 0.839798 2.51939 6.71838 2.9976e-15 -1.49186e-15 -3.69149e-15 +423 1 0.839798 1.6796 7.55818 2.55351e-15 7.49401e-16 8.88178e-16 +424 1 0 2.51939 7.55818 -8.88178e-15 -2.28983e-15 8.88178e-16 +425 1 1.6796 1.6796 6.71838 2.08167e-16 -7.63278e-16 -3.20577e-15 +426 1 2.51939 2.51939 6.71838 -1.38778e-15 -1.06165e-15 -4.37844e-15 +427 1 2.51939 1.6796 7.55818 -1.4988e-15 3.33067e-16 -3.26128e-16 +428 1 1.6796 2.51939 7.55818 1.38778e-16 -1.4988e-15 3.05311e-16 +429 1 3.35919 1.6796 6.71838 1.30312e-14 -8.95117e-16 -3.41394e-15 +430 1 4.19899 2.51939 6.71838 -2.33355e-14 -1.58901e-15 -5.10703e-15 +431 1 4.19899 1.6796 7.55818 -2.35506e-14 -4.23273e-16 3.46945e-17 +432 1 3.35919 2.51939 7.55818 1.32186e-14 -1.16573e-15 8.04912e-16 +433 1 5.03879 1.6796 6.71838 0 -5.68989e-16 -2.42861e-15 +434 1 5.87859 2.51939 6.71838 2.25098e-14 -1.25594e-15 -3.50414e-15 +435 1 5.87859 1.6796 7.55818 2.22322e-14 -6.93889e-17 2.28983e-16 +436 1 5.03879 2.51939 7.55818 3.60822e-16 -1.60982e-15 1.11022e-15 +437 1 6.71838 1.6796 6.71838 -3.21271e-15 -5.06539e-16 -3.48332e-15 +438 1 7.55818 2.51939 6.71838 -2.22045e-16 -1.77636e-15 -3.44169e-15 +439 1 7.55818 1.6796 7.55818 8.88178e-16 2.08167e-16 4.44089e-16 +440 1 6.71838 2.51939 7.55818 -2.60902e-15 -9.85323e-16 -2.498e-16 +441 1 0 3.35919 6.71838 -1.02141e-14 1.33227e-14 -3.33067e-15 +442 1 0.839798 4.19899 6.71838 2.77556e-15 -2.37171e-14 -3.94129e-15 +443 1 0.839798 3.35919 7.55818 2.55351e-15 1.37113e-14 1.94289e-15 +444 1 0 4.19899 7.55818 -7.99361e-15 -2.4647e-14 -6.66134e-16 +445 1 1.6796 3.35919 6.71838 2.22045e-16 1.2601e-14 -1.94289e-15 +446 1 2.51939 4.19899 6.71838 -1.70697e-15 -2.30926e-14 -4.66294e-15 +447 1 2.51939 3.35919 7.55818 -1.94289e-15 1.33227e-14 1.77636e-15 +448 1 1.6796 4.19899 7.55818 -6.38378e-16 -2.30926e-14 1.9984e-15 +449 1 3.35919 3.35919 6.71838 1.28439e-14 1.19904e-14 -2.05391e-15 +450 1 4.19899 4.19899 6.71838 -2.41265e-14 -2.22045e-14 -3.55271e-15 +451 1 4.19899 3.35919 7.55818 -2.48274e-14 1.02141e-14 8.88178e-16 +452 1 3.35919 4.19899 7.55818 1.20182e-14 -2.30926e-14 2.22045e-16 +453 1 5.03879 3.35919 6.71838 -2.35922e-16 9.49241e-15 -1.9984e-15 +454 1 5.87859 4.19899 6.71838 2.29608e-14 -2.39808e-14 -4.66294e-15 +455 1 5.87859 3.35919 7.55818 2.30649e-14 1.15463e-14 1.33227e-15 +456 1 5.03879 4.19899 7.55818 2.77556e-17 -2.30926e-14 1.55431e-15 +457 1 6.71838 3.35919 6.71838 -3.13638e-15 1.16851e-14 -2.09555e-15 +458 1 7.55818 4.19899 6.71838 -2.22045e-16 -2.5091e-14 -2.10942e-15 +459 1 7.55818 3.35919 7.55818 -8.88178e-16 1.28231e-14 4.44089e-16 +460 1 6.71838 4.19899 7.55818 -3.4972e-15 -2.54935e-14 9.99201e-16 +461 1 0 5.03879 6.71838 -7.10543e-15 8.88178e-16 -3.9968e-15 +462 1 0.839798 5.87859 6.71838 2.66454e-15 2.20796e-14 -3.27516e-15 +463 1 0.839798 5.03879 7.55818 3.10862e-15 4.02456e-16 -5.55112e-16 +464 1 0 5.87859 7.55818 -5.32907e-15 2.28151e-14 -2.22045e-16 +465 1 1.6796 5.03879 6.71838 4.44089e-16 -5.55112e-16 -2.63678e-15 +466 1 2.51939 5.87859 6.71838 -1.33227e-15 2.24265e-14 -3.08087e-15 +467 1 2.51939 5.03879 7.55818 -2.13024e-15 3.33067e-16 -3.88578e-16 +468 1 1.6796 5.87859 7.55818 4.57967e-16 2.30371e-14 4.51028e-16 +469 1 3.35919 5.03879 6.71838 1.02279e-14 -1.11022e-16 -2.58127e-15 +470 1 4.19899 5.87859 6.71838 -2.37588e-14 2.30926e-14 -3.37924e-15 +471 1 4.19899 5.03879 7.55818 -2.2489e-14 -2.22045e-16 -3.33067e-16 +472 1 3.35919 5.87859 7.55818 1.17684e-14 2.40502e-14 9.4369e-16 +473 1 5.03879 5.03879 6.71838 2.15106e-16 2.22045e-16 -2.83107e-15 +474 1 5.87859 5.87859 6.71838 2.28706e-14 2.26485e-14 -3.66374e-15 +475 1 5.87859 5.03879 7.55818 2.09346e-14 -3.33067e-16 -1.94289e-16 +476 1 5.03879 5.87859 7.55818 2.35922e-16 2.18159e-14 8.39606e-16 +477 1 6.71838 5.03879 6.71838 -3.3723e-15 -2.63678e-16 -2.04003e-15 +478 1 7.55818 5.87859 6.71838 -2.22045e-16 2.44249e-14 -4.27436e-15 +479 1 7.55818 5.03879 7.55818 -8.88178e-16 1.249e-16 -2.22045e-16 +480 1 6.71838 5.87859 7.55818 -3.55271e-15 2.49384e-14 -2.22045e-16 +481 1 0 6.71838 6.71838 -8.88178e-15 -3.9968e-15 -2.88658e-15 +482 1 0.839798 7.55818 6.71838 2.33147e-15 -2.77556e-16 -2.94209e-15 +483 1 0.839798 6.71838 7.55818 2.77556e-15 -2.8727e-15 -3.88578e-16 +484 1 0 7.55818 7.55818 -9.76996e-15 -4.44089e-16 -6.66134e-16 +485 1 1.6796 6.71838 6.71838 2.15106e-16 -3.93435e-15 -3.94129e-15 +486 1 2.51939 7.55818 6.71838 -2.44249e-15 -1.66533e-16 -3.60822e-15 +487 1 2.51939 6.71838 7.55818 -1.249e-15 -2.83107e-15 -7.21645e-16 +488 1 1.6796 7.55818 7.55818 0 4.44089e-16 8.88178e-16 +489 1 3.35919 6.71838 6.71838 1.22749e-14 -3.60129e-15 -4.05231e-15 +490 1 4.19899 7.55818 6.71838 -2.59862e-14 2.22045e-16 -3.27516e-15 +491 1 4.19899 6.71838 7.55818 -2.56323e-14 -3.9968e-15 -9.99201e-16 +492 1 3.35919 7.55818 7.55818 1.15741e-14 6.66134e-16 0 +493 1 5.03879 6.71838 6.71838 0 -3.25434e-15 -4.08007e-15 +494 1 5.87859 7.55818 6.71838 2.46539e-14 6.66134e-16 -2.66454e-15 +495 1 5.87859 6.71838 7.55818 2.4189e-14 -3.44169e-15 -2.22045e-16 +496 1 5.03879 7.55818 7.55818 0 2.22045e-16 4.44089e-16 +497 1 6.71838 6.71838 6.71838 -2.58127e-15 -4.07313e-15 -3.92741e-15 +498 1 7.55818 7.55818 6.71838 -2.22045e-16 0 -3.05311e-15 +499 1 7.55818 6.71838 7.55818 0 -2.72005e-15 -1.33227e-15 +500 1 6.71838 7.55818 7.55818 -3.9968e-15 2.35922e-16 -2.22045e-16 +ITEM: TIMESTEP +100 +ITEM: NUMBER OF ATOMS +500 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +ITEM: ATOMS id type x y z f_2[1] f_2[2] f_2[3] +1 1 0.123071 8.38872 8.3161 -13.5034 12.7208 4.27264 +2 1 0.832093 0.789482 0.0260634 11.6405 -9.02308 5.27054 +3 1 0.829348 8.32295 0.847054 0.253685 2.42198 0.190462 +4 1 0.167866 0.883683 1.1203 3.78838 -17.5987 -23.5446 +5 1 1.84325 0.268983 0.0506746 -34.1939 -23.1747 -16.5239 +6 1 2.48966 1.02521 0.0150167 17.3336 21.4777 -8.17686 +7 1 2.69085 0.133161 0.584204 54.6376 -37.2919 -8.47938 +8 1 2.03129 0.673907 1.00581 -42.9604 37.8091 32.6152 +9 1 3.4644 0.135395 8.22513 6.66121 1.25052 1.24977 +10 1 4.03955 1.11148 8.14659 12.0412 -8.97859 6.48992 +11 1 4.19379 0.0448744 0.829139 -7.8302 -27.8417 -6.76025 +12 1 3.64841 0.913699 0.700293 -19.72 -1.80986 -1.25088 +13 1 4.95468 8.24864 0.0754237 1.84477 -0.530278 -6.08608 +14 1 5.56087 0.715896 7.89459 8.56765 -1.46102 11.0915 +15 1 5.88623 0.0411411 0.556827 1.26181 -8.5789 -11.0866 +16 1 4.92937 0.724638 0.812217 17.273 10.8714 -8.85433 +17 1 6.72739 8.38085 8.13417 -35.3805 -5.9515 28.6252 +18 1 7.72548 0.788736 0.0488514 2.00593 -21.6326 -29.6842 +19 1 7.72508 8.25409 0.930095 1.50566 4.42937 -3.62071 +20 1 6.80396 0.557293 0.840198 23.1381 -17.3706 0.134541 +21 1 0.229449 1.60533 8.39298 -14.4977 16.7962 1.07689 +22 1 0.832071 2.6454 0.0244343 3.40253 -11.2938 10.3532 +23 1 1.17502 1.54184 1.17348 -25.8959 -2.9461 -24.9151 +24 1 0.259004 2.30396 1.08005 -0.921709 -4.92947 -4.61717 +25 1 1.52612 1.69846 0.0790119 2.24081 -1.66091 4.11232 +26 1 2.32335 2.59169 0.0356063 -1.33192 -7.27448 11.4357 +27 1 2.47613 1.68798 0.866847 -6.11708 -1.09078 12.1273 +28 1 1.75964 2.46963 1.02161 -10.4242 6.62214 -9.26339 +29 1 3.18899 1.91192 0.152422 12.8306 -10.0239 -26.2805 +30 1 4.16606 2.56561 0.31819 6.19268 17.1047 -29.5908 +31 1 4.20679 1.77492 0.904599 6.39419 -20.2587 16.143 +32 1 3.29457 2.54016 0.942536 8.4707 7.62624 9.38928 +33 1 5.08962 1.70142 0.228194 -1.96985 -10.7878 -18.1781 +34 1 5.8401 2.50153 8.17919 2.2116 -4.35098 8.5453 +35 1 6.13077 1.14332 0.361455 -13.4767 12.4455 -5.6398 +36 1 5.21187 2.29543 1.04708 -21.2445 17.0192 -2.44157 +37 1 7.1904 2.12537 8.11861 -26.262 1.63538 -8.89421 +38 1 7.82272 2.3769 0.452291 6.46918 9.92036 10.2415 +39 1 7.65568 1.36632 0.837818 -8.61574 34.9087 15.0511 +40 1 6.63096 2.29607 0.833592 -3.02945 -9.31899 -38.2195 +41 1 0.0701224 3.26957 0.347776 -7.76983 -4.00147 -12.0182 +42 1 0.634247 4.2146 8.13102 5.69069 28.6823 19.9973 +43 1 0.89062 3.25892 1.01274 -8.90571 5.17288 9.1951 +44 1 8.35578 4.21333 0.756755 0.0651816 10.3427 6.16366 +45 1 1.59376 3.50824 0.337522 12.8481 -18.5931 -31.178 +46 1 2.63362 4.08805 -0.0117409 -13.6881 -31.4545 31.8377 +47 1 2.64545 3.44217 0.972182 1.32962 4.76915 -6.91838 +48 1 1.77157 4.31331 0.893182 6.24463 15.8362 30.2465 +49 1 3.30506 3.15734 -0.00281637 -4.50664 8.90697 10.0795 +50 1 4.20121 3.98351 8.24532 14.9588 -4.89636 4.16185 +51 1 4.14049 3.34001 1.03567 7.31744 -35.2634 -0.734077 +52 1 3.55633 4.09497 0.714486 -22.5487 2.59697 3.44603 +53 1 5.00488 3.2958 8.40544 4.72004 -3.7586 -0.0676635 +54 1 6.02419 4.38739 8.28472 2.63675 -3.85348 -7.36203 +55 1 5.82125 3.13701 0.812331 3.285 1.60137 -0.83853 +56 1 4.81191 4.1205 0.886429 26.0514 -19.7571 -10.6482 +57 1 6.37904 3.38462 8.29958 8.77859 5.40588 1.21659 +58 1 7.16155 4.27433 8.23885 -4.15514 -15.8519 20.8515 +59 1 7.46381 3.5222 0.62725 -6.50801 1.62892 11.1525 +60 1 6.52496 4.16064 0.796816 7.21171 -6.93074 -7.48151 +61 1 8.21062 5.02405 8.32529 2.06274 -1.43255 -7.09188 +62 1 0.856242 5.68027 8.15143 -7.33544 -9.25849 21.6195 +63 1 0.668812 5.05722 1.0253 10.4106 -11.6037 -16.0599 +64 1 0.100757 5.9519 0.987463 -8.02818 6.7945 -7.41084 +65 1 1.67634 4.74298 8.35528 -7.26839 1.52359 -11.0387 +66 1 2.38848 5.51086 0.107164 2.54651 6.03927 1.46743 +67 1 2.70757 4.93813 1.01132 -4.75577 -9.71554 1.13089 +68 1 1.3925 5.83052 0.707681 -1.14437 -6.44566 7.34655 +69 1 3.45574 4.66587 8.23291 4.73605 39.4767 5.5614 +70 1 4.43743 5.80479 0.164115 -6.64024 0.386075 1.78009 +71 1 4.2065 4.90669 0.741814 -23.5797 23.1046 -22.8102 +72 1 3.32112 5.74269 0.715517 7.3169 4.77905 3.84994 +73 1 5.16076 4.9557 8.31038 -10.6163 5.08193 1.86037 +74 1 5.94307 5.96922 0.174598 0.307423 -9.87615 -0.075099 +75 1 5.67998 4.99641 0.866467 -3.37502 0.387608 -1.06988 +76 1 5.10533 6.15466 0.974945 -0.684733 -17.9465 -18.2172 +77 1 6.66954 5.212 0.215572 3.55269 -19.7927 -9.30717 +78 1 7.63194 6.03007 0.0625005 22.452 -11.4487 -13.3981 +79 1 7.77987 5.15692 0.880268 -13.4303 3.64316 1.97115 +80 1 6.9443 6.00859 0.774386 -22.1564 -21.0173 44.3085 +81 1 0.211543 6.60981 0.114883 -6.22763 -3.96979 4.85396 +82 1 0.828363 7.71074 8.05758 6.57912 -12.175 1.18202 +83 1 0.8511 6.85772 1.00145 14.3344 -16.9148 6.86093 +84 1 0.108182 7.491 0.729711 -16.3275 13.3125 -2.16192 +85 1 1.32651 6.53754 8.31267 17.3977 32.295 0.779922 +86 1 2.45313 7.32438 0.161863 4.38219 8.94585 -15.0057 +87 1 2.22206 6.5101 0.817864 2.61276 2.64125 -0.96007 +88 1 1.71157 7.54558 0.836721 -10.8648 3.37169 8.49449 +89 1 3.33137 6.74361 0.251121 4.01956 -5.07144 -3.19134 +90 1 4.31785 7.3164 0.250439 -2.62105 14.0423 -19.3334 +91 1 4.11403 6.69271 1.01148 -3.23605 5.58393 9.21791 +92 1 3.25046 7.65301 0.863299 7.69366 -3.67127 3.31805 +93 1 5.15822 6.61638 8.39412 -15.5898 18.5262 -4.77657 +94 1 5.88176 7.47131 8.35911 1.25772 40.9097 -41.218 +95 1 5.8589 6.89406 0.716878 17.4729 -36.9167 60.1945 +96 1 5.1317 7.5805 0.887324 -15.4398 8.72154 0.622041 +97 1 6.7242 6.72984 0.126171 2.95649 13.978 -28.6002 +98 1 7.71076 7.70275 8.27387 -25.252 1.96163 47.723 +99 1 7.67756 6.66145 0.969756 13.165 19.6736 4.48693 +100 1 6.86126 7.61056 0.694229 -2.98636 3.99324 3.02821 +101 1 8.36607 8.27958 1.86716 -0.17632 -3.19355 -10.789 +102 1 0.956051 0.693329 1.82901 -1.1092 0.489919 9.03263 +103 1 0.677954 8.19357 2.69404 9.64796 -1.44576 4.92708 +104 1 8.40822 0.658358 2.57043 0.358989 35.1247 -30.1625 +105 1 1.59709 8.27384 1.6579 -3.48424 8.95256 3.83776 +106 1 2.60262 0.937274 1.91114 -6.85695 -44.4167 -8.16487 +107 1 2.77964 8.33738 2.42411 -9.97653 17.8509 12.2111 +108 1 1.80103 0.545423 2.70436 3.05773 -0.374817 -3.43865 +109 1 3.48439 0.0645578 1.59153 -12.2456 1.16104 1.511 +110 1 4.22306 0.908637 1.62246 8.21176 3.032 -1.28199 +111 1 4.10829 0.251535 2.42791 -11.6297 -7.60593 -5.50766 +112 1 3.3006 0.854758 2.76304 -19.992 -17.3193 -31.4497 +113 1 4.89013 8.37666 1.691 47.9119 57.0599 0.585594 +114 1 5.94061 0.477826 1.48406 -3.07899 1.88699 12.3275 +115 1 5.88048 0.35971 2.56281 -4.35157 -20.3865 4.17854 +116 1 4.9283 1.00358 2.55425 0.721177 -5.70224 -8.52683 +117 1 6.83323 8.16485 1.66012 -9.63203 10.6138 -6.53177 +118 1 7.60236 0.72315 1.6205 1.19764 -13.0731 15.2148 +119 1 7.46261 8.34785 2.50942 4.27014 7.86644 3.21827 +120 1 6.98477 1.01167 2.43863 -2.7077 -3.72405 10.5475 +121 1 0.201795 1.49879 1.91201 12.0746 15.4759 7.55997 +122 1 0.970651 2.5763 1.77546 9.10281 -9.21672 19.206 +123 1 1.00278 1.70354 2.64935 -4.86832 -2.32063 -12.0578 +124 1 0.220174 2.4694 2.59226 -6.06395 2.41662 -4.31274 +125 1 1.87438 1.66139 1.85364 0.0891009 8.26815 7.54904 +126 1 2.5634 2.61259 1.66324 -1.39613 -9.56029 15.7565 +127 1 2.67373 1.74855 2.48368 16.2507 26.3662 25.5413 +128 1 1.81271 2.51993 2.48462 -12.4635 -12.9481 6.24626 +129 1 3.34642 1.5174 1.55361 6.72778 19.0825 -4.097 +130 1 4.08393 2.3973 1.7811 -4.91883 6.9472 -7.45962 +131 1 3.95017 1.57032 2.47783 9.96822 8.42852 -4.63348 +132 1 3.54843 2.54548 2.73936 0.891724 -11.4891 -8.75214 +133 1 5.35058 1.38537 1.51823 -3.50731 -2.89085 5.66595 +134 1 6.023 2.29204 1.65213 -4.43652 -0.464129 22.1024 +135 1 5.94747 1.35093 2.39209 2.54676 22.9646 2.61125 +136 1 4.92685 2.18916 2.37644 10.4243 -2.12633 1.01963 +137 1 6.61187 1.36453 1.49274 0.221959 8.29598 -0.620687 +138 1 7.32473 2.28685 1.57865 28.4734 -28.9459 -8.73783 +139 1 7.72873 1.81047 2.35176 -1.00775 -9.06934 31.0045 +140 1 6.61584 2.21437 2.52479 7.01251 0.0677084 2.80218 +141 1 8.39022 3.27891 1.73012 3.49525 -5.17929 -4.65996 +142 1 0.854964 4.19407 1.69788 1.56946 -2.00702 1.06174 +143 1 0.997978 3.23715 2.67504 2.30643 5.8223 1.06858 +144 1 7.97382 3.9138 2.48815 10.0732 9.91828 -12.5132 +145 1 1.83784 3.47408 1.69517 -12.404 -3.21409 -2.66267 +146 1 2.61842 4.21682 1.90008 2.14748 0.059531 -3.785 +147 1 2.48603 3.26502 2.5249 16.8304 14.9965 0.171158 +148 1 1.68761 4.23907 2.52806 -1.01396 -4.72261 -0.795752 +149 1 3.40602 3.2813 1.85914 -16.1626 0.355927 -8.83409 +150 1 4.09906 4.10307 1.70079 5.35563 8.08157 -4.08084 +151 1 4.20252 3.30769 2.50236 16.5461 8.94662 0.427258 +152 1 3.52577 4.20363 2.52362 -12.9682 0.481811 23.6133 +153 1 5.11847 3.18122 1.75203 -10.5302 -5.4337 -0.263304 +154 1 5.84661 3.9209 1.56262 -0.517958 8.86577 8.63788 +155 1 5.86922 3.05768 2.56393 3.07392 -0.105811 -3.05554 +156 1 4.80787 4.20147 2.51562 -15.5306 -18.6016 6.98719 +157 1 6.75594 3.06184 1.51831 -23.9843 53.9056 5.35996 +158 1 7.37411 4.33015 1.50837 10.7935 -8.89263 2.38858 +159 1 7.49772 2.90887 2.46868 -6.63254 10.1343 -14.9923 +160 1 6.70853 3.86113 2.32478 1.28299 1.19192 -0.76331 +161 1 8.35107 4.97447 1.76826 -6.01727 -4.60108 12.0065 +162 1 0.812206 5.83167 1.72433 7.83055 6.4827 17.8655 +163 1 0.780537 4.91988 2.60048 6.34607 -5.57446 -13.8552 +164 1 8.22728 5.818 2.44166 16.0462 -1.57715 15.6299 +165 1 1.69572 5.11642 1.80574 -4.96566 -14.135 -5.31489 +166 1 2.43043 5.85297 1.63568 5.29915 -1.62077 5.85546 +167 1 2.57792 5.02783 2.65315 -4.52746 -19.2236 -8.91777 +168 1 1.53526 5.79854 2.60003 3.8059 -10.2938 -9.84612 +169 1 3.51815 5.02648 1.76532 -11.6984 -21.692 -35.1665 +170 1 4.20879 5.78771 1.44267 -4.45704 -9.43328 11.2812 +171 1 4.17986 5.08228 2.52246 26.037 -4.72131 -0.0794421 +172 1 3.28564 5.71935 2.4374 15.7539 34.931 2.27384 +173 1 4.77269 4.90482 1.56605 20.4715 8.53759 27.1606 +174 1 6.0822 5.98003 1.39493 -10.1112 -7.66907 2.17662 +175 1 5.55864 4.81486 2.32198 32.4427 -4.71792 -40.0608 +176 1 5.42317 5.8389 2.32907 -1.32862 11.7729 0.869635 +177 1 6.58632 5.00994 1.4228 1.50987 11.9718 7.91199 +178 1 7.40728 5.76017 1.85143 -17.7756 -1.69935 -20.7445 +179 1 7.43483 4.90248 2.50406 4.81208 -4.17509 -3.00519 +180 1 6.49032 6.25339 2.53785 -9.86939 -13.1275 -11.226 +181 1 8.38687 6.70803 1.84686 8.51598 2.67685 -7.76441 +182 1 0.82672 7.5809 1.8586 -8.65199 -8.55201 -6.88257 +183 1 0.798368 6.66179 2.58415 -9.89719 -0.151349 -9.60426 +184 1 8.09266 7.50342 2.71078 14.8523 -0.33865 -5.72558 +185 1 1.67226 6.92941 1.90638 3.68667 -6.81729 -3.8166 +186 1 2.44977 7.72472 1.67328 13.6121 -19.3583 -10.8323 +187 1 2.6005 7.00136 2.53195 -4.75836 -8.709 1.95523 +188 1 1.74762 7.69197 2.71318 -2.53247 4.05033 -0.19863 +189 1 3.12318 6.68472 1.56494 -10.4586 3.85751 -11.4518 +190 1 4.29009 7.65387 1.60791 -51.7416 -54.1223 -14.9832 +191 1 3.94907 6.70085 2.16915 18.0446 -8.10905 7.08373 +192 1 3.47208 7.58339 2.49347 14.5465 5.92984 -2.02778 +193 1 5.12563 6.77282 1.76131 -9.48863 14.4825 6.97263 +194 1 5.83539 7.62987 1.64588 8.72191 3.82062 7.16953 +195 1 5.76423 6.96836 2.55864 -5.64345 11.6948 11.2338 +196 1 4.77822 7.71547 2.51809 6.21883 -11.3323 9.13654 +197 1 6.63559 6.81418 1.65333 9.11964 14.1494 -8.37133 +198 1 7.61434 7.47455 1.72558 2.40335 0.461228 -6.0911 +199 1 7.4792 6.66861 2.39873 -2.80551 0.930229 8.6336 +200 1 6.74988 7.49855 2.51532 0.27108 -2.11137 5.23264 +201 1 8.33028 0.11458 3.36279 -16.5826 -29.3888 39.8482 +202 1 0.924222 0.663074 3.34599 -4.22349 8.71948 1.26084 +203 1 0.761543 8.18959 3.97906 2.12091 4.50677 4.24971 +204 1 8.33433 0.813163 4.20564 6.5007 1.52148 -0.192127 +205 1 1.76574 0.0375621 3.77071 17.3013 -16.3871 -16.9245 +206 1 2.61977 0.818953 3.52119 -23.2651 -2.55324 12.2346 +207 1 2.77562 0.0652161 4.44741 -11.8421 6.13727 -13.8855 +208 1 1.49199 0.761034 4.41597 -5.10709 15.0925 14.5126 +209 1 3.2179 8.34804 3.44668 5.27936 -7.50847 -1.90568 +210 1 3.9439 0.797129 3.52456 17.3728 2.18733 11.5361 +211 1 4.23279 0.116688 4.32559 -2.42219 -2.56552 -2.26636 +212 1 3.32804 0.997948 4.36883 1.65433 -5.54648 3.47818 +213 1 4.71275 0.120112 3.21294 23.362 4.56383 23.3458 +214 1 5.81093 1.04185 3.50642 -3.03834 -26.4106 -17.8435 +215 1 5.68877 0.288558 4.20831 -1.41276 -13.7346 9.5471 +216 1 5.01865 1.1392 4.32627 0.968145 -3.23051 -6.43149 +217 1 6.64793 8.39618 3.24984 2.09632 -4.36032 3.69009 +218 1 7.5883 0.965027 3.40354 -4.44096 -3.20185 -1.58139 +219 1 7.46506 8.38162 4.26807 1.21074 2.40143 -20.8016 +220 1 6.68567 0.729309 4.05423 9.00491 -0.0257829 7.04417 +221 1 0.0217051 1.65067 3.33296 -0.896942 -12.0422 -1.44038 +222 1 0.778955 2.33585 3.53158 8.17696 34.6193 -17.2054 +223 1 0.812105 1.63712 4.22741 2.15493 -21.1842 9.58449 +224 1 8.36402 2.71734 4.23224 9.90405 -0.180735 2.89262 +225 1 1.64503 1.55583 3.44456 9.91651 -2.24847 10.5707 +226 1 2.72789 2.60115 3.33289 -22.1633 -6.4618 14.3253 +227 1 2.53285 1.75288 4.15927 -11.2604 4.59027 8.59695 +228 1 1.59486 2.51559 4.29587 -0.634079 -19.903 20.3392 +229 1 3.26158 1.6458 3.43181 16.9482 17.4067 -1.31054 +230 1 4.49124 2.67296 3.29881 0.516577 8.93567 6.85853 +231 1 4.12441 1.76399 4.16025 -12.4119 -16.9863 20.8263 +232 1 3.58648 2.62356 4.12513 -11.0948 -0.0880381 2.09248 +233 1 4.62064 1.66433 3.30411 17.3359 -14.3916 -7.7698 +234 1 5.72203 2.02067 3.4449 -2.49843 31.6335 -13.0426 +235 1 6.15135 1.60495 4.33133 -9.75959 4.02084 8.19224 +236 1 5.04088 2.23941 4.27882 30.2001 -2.39587 -19.7025 +237 1 6.91779 1.8813 3.52264 3.96777 -26.054 4.41687 +238 1 7.81771 2.53776 3.353 -2.77684 -3.41763 12.6677 +239 1 7.78069 1.81171 4.34601 -52.3825 1.07947 -51.791 +240 1 6.66141 2.49312 4.62997 -6.69802 -0.0628228 -12.7191 +241 1 0.122629 3.46604 3.3479 -1.26446 -22.7991 -11.2332 +242 1 0.85888 4.22824 3.46647 2.79502 3.87933 -3.60293 +243 1 0.937247 3.40088 4.29114 -12.1658 -1.27655 -7.25993 +244 1 8.30307 4.19021 4.02192 -7.37977 10.0618 19.4199 +245 1 1.73804 3.18337 3.5685 -15.8464 9.26468 -37.1326 +246 1 2.58615 4.05913 3.19953 0.360202 14.7294 -1.16411 +247 1 2.55925 3.4674 4.05471 16.7959 -2.51521 13.6147 +248 1 1.75131 4.20697 4.04231 3.51698 -5.56503 7.27084 +249 1 3.44857 3.37138 3.44602 9.39764 18.3315 -14.5187 +250 1 4.30487 4.37452 3.51867 -0.743412 -11.0963 -4.3924 +251 1 4.41614 3.34547 4.13696 17.6233 7.57534 -14.2893 +252 1 3.32801 4.25542 4.08286 6.07649 -1.13934 3.22429 +253 1 5.63651 3.09553 3.631 -4.7187 3.44811 6.48572 +254 1 5.99275 4.08946 3.17209 -2.06613 -3.23888 -8.73239 +255 1 6.47603 3.67609 4.18744 -9.24013 0.891239 -0.0265923 +256 1 5.32989 4.17403 4.01248 -3.14576 -0.648453 6.26049 +257 1 6.72457 2.86539 3.51605 -3.69406 17.3565 -4.96963 +258 1 7.32281 3.76777 3.25105 -10.2265 -1.63605 18.2335 +259 1 7.4303 3.25631 4.3358 5.44768 7.87627 -9.74689 +260 1 6.66407 4.65396 3.76405 -6.96361 -4.18223 2.73914 +261 1 8.26711 4.8857 3.17584 6.51218 -0.295316 -2.27808 +262 1 0.649285 5.74933 3.20979 -12.9544 -9.12523 -13.313 +263 1 1.01858 5.10915 4.40565 1.04387 0.402418 -2.70019 +264 1 0.0855082 5.80312 4.16158 -11.0199 -7.09759 8.81305 +265 1 1.78399 4.97143 3.32025 -23.7199 7.54456 -3.60592 +266 1 2.55969 5.96317 3.12483 -8.84523 11.7944 16.8138 +267 1 2.653 5.05017 3.85074 -4.37713 4.79953 16.9312 +268 1 2.04667 5.9581 4.23583 -12.9689 -9.50066 -2.67062 +269 1 3.52568 5.09169 3.32195 -1.60301 -3.74832 -0.530875 +270 1 4.17719 5.92991 3.13207 5.79449 2.84869 4.98978 +271 1 4.69237 5.20087 4.04914 -22.9168 0.480558 19.5714 +272 1 3.49623 5.87284 4.08872 -22.1914 -19.7939 -11.835 +273 1 5.22134 4.9979 3.22696 -11.435 -2.89555 -13.2152 +274 1 5.65705 6.11892 3.42751 2.78011 1.11701 -3.25891 +275 1 5.76121 5.22134 4.03501 7.67556 -2.59727 25.3068 +276 1 4.95772 6.04539 4.58052 58.0203 8.0254 -45.1554 +277 1 6.4538 5.11955 2.78748 -4.74406 7.07146 5.73728 +278 1 7.21538 5.95413 3.16364 10.7768 -10.9442 6.36207 +279 1 7.51809 5.20099 3.85697 17.9797 5.14787 9.68311 +280 1 6.63903 5.76912 4.06379 2.12496 12.0521 4.75162 +281 1 8.12324 6.45888 3.3557 6.09728 0.195353 -8.64393 +282 1 0.462088 7.19726 3.46792 19.553 -0.0547515 -15.4409 +283 1 0.957118 6.33073 3.94731 10.4711 20.6934 10.8557 +284 1 8.31788 7.62476 4.18946 -15.5996 1.5203 27.0435 +285 1 1.621 6.60508 3.20723 21.3874 20.2704 9.57573 +286 1 2.43565 7.40381 3.575 -2.23423 10.7661 -7.60718 +287 1 2.75508 6.70843 4.26783 9.69215 -9.86312 8.63304 +288 1 1.4194 7.32943 4.0782 6.712 1.12768 -13.3449 +289 1 3.55435 6.77984 3.25216 -11.0849 -3.43265 4.44657 +290 1 4.09983 7.6717 3.40332 0.775894 2.91256 6.51607 +291 1 4.08342 6.6168 4.34423 8.99422 27.9061 4.38721 +292 1 3.36001 7.55781 4.25663 44.0502 4.81661 -43.4399 +293 1 4.74991 6.77738 3.51304 4.59094 -3.55683 -10.177 +294 1 5.77556 7.6737 3.71378 -0.245399 -1.3978 -0.93703 +295 1 5.90589 6.74801 4.34426 -3.316 -4.25196 -0.216303 +296 1 4.8074 7.40991 4.34207 4.23627 19.8452 -2.32284 +297 1 6.58813 6.85169 3.45364 -7.67639 -5.27403 -11.3349 +298 1 7.50241 7.47925 3.56723 2.18816 13.5038 -24.0989 +299 1 7.40344 6.62065 4.10638 -2.8935 -4.19323 5.51308 +300 1 6.75843 7.5046 4.25149 -20.47 8.43665 16.7865 +301 1 8.33167 8.36145 4.9892 0.225809 34.2346 -31.8957 +302 1 0.576342 0.867151 5.40959 24.5697 -12.6304 -33.2572 +303 1 0.763006 0.00458111 6.00676 12.4506 6.43147 -2.11226 +304 1 8.26499 0.860176 6.08382 -7.17683 -4.07129 -51.5552 +305 1 1.81244 8.0383 4.87052 -5.76863 7.26347 -9.86755 +306 1 2.53533 1.09902 5.19234 -3.16803 0.678291 -2.97003 +307 1 2.78135 0.403413 6.40689 -26.816 9.12488 -11.3363 +308 1 1.58905 0.651353 5.66283 7.03419 0.981612 1.76622 +309 1 3.32058 0.106866 5.32447 -0.932856 13.5857 14.9154 +310 1 4.27557 0.92435 5.10725 -6.99093 5.63655 -6.45098 +311 1 4.28959 0.280237 5.95961 -30.2191 -30.0316 -14.6333 +312 1 3.38904 1.26869 5.835 20.8336 -7.28254 -13.6106 +313 1 5.00946 8.32617 5.09801 -7.438 6.03549 0.926349 +314 1 5.92216 0.863628 5.14574 -0.277075 -6.34381 -3.05305 +315 1 5.73427 0.0193827 5.90902 4.17974 0.428592 2.11829 +316 1 4.94752 0.963499 5.95092 36.9682 12.4342 8.28196 +317 1 6.68007 0.0753806 5.17719 -6.21888 -0.275929 -7.94036 +318 1 7.59475 0.718477 4.99 5.56935 4.26124 12.8688 +319 1 7.48253 8.3166 5.84711 10.9136 10.2783 15.4989 +320 1 6.8326 0.897437 5.9487 8.18452 -13.9005 5.8213 +321 1 0.0760609 1.64664 4.96296 26.1716 -2.70613 34.3225 +322 1 0.685552 2.56455 5.03633 12.0035 4.84556 -15.2829 +323 1 0.606729 1.82267 5.82598 7.27963 -3.46786 12.0617 +324 1 8.3293 2.58271 5.72712 2.9601 13.0212 32.1025 +325 1 1.39999 1.70565 5.12122 8.3487 -4.09076 2.04128 +326 1 2.73507 2.85653 4.90403 -0.345779 -0.804973 -4.73226 +327 1 2.41817 2.24309 5.70209 1.42091 -4.90412 -0.964796 +328 1 1.38108 2.54746 5.86585 12.2906 4.17611 0.525771 +329 1 3.33731 1.91289 4.90293 0.0185627 0.794978 8.4213 +330 1 4.3973 2.60866 4.92615 -15.1153 4.67891 22.5372 +331 1 4.2225 2.0218 5.81106 18.0418 -47.4422 -19.4137 +332 1 3.4994 2.65878 5.66207 -24.6152 28.1329 2.91513 +333 1 5.20081 1.64695 5.25699 -1.61968 25.0354 -10.6249 +334 1 5.90254 2.56674 5.38347 4.70787 3.18361 -12.95 +335 1 6.08989 1.61464 5.89214 -10.9271 -1.55847 2.77666 +336 1 5.02754 2.69198 5.87273 -13.869 2.1523 1.52243 +337 1 6.90208 1.46146 5.07178 -10.118 15.4867 -8.4201 +338 1 7.58477 2.54489 5.07036 0.223295 2.60985 -3.71518 +339 1 7.69807 1.70404 5.74305 2.65747 -7.01835 5.70621 +340 1 6.83671 2.31874 5.77518 8.75763 5.85965 2.81961 +341 1 8.33535 3.4475 5.0472 4.04483 5.65066 -3.26522 +342 1 0.908217 4.16423 5.06292 -2.0575 1.13184 -0.501506 +343 1 0.771491 3.42595 5.87741 5.33449 1.31478 -10.6197 +344 1 0.14652 4.33584 6.04676 1.00462 -8.1578 -20.2597 +345 1 1.77294 3.51463 4.93957 -1.27898 -7.63546 3.32247 +346 1 2.71396 3.96357 4.97834 15.9141 3.79204 10.1307 +347 1 2.46159 3.38803 6.16546 -1.0491 -20.8555 -15.9327 +348 1 1.72608 4.39112 6.04032 -15.046 -11.018 -10.0045 +349 1 3.71274 3.40467 4.85974 -22.3519 13.9348 10.8973 +350 1 4.57553 4.21697 4.87404 -3.96399 7.00234 -1.98713 +351 1 4.366 3.53193 5.70269 7.89254 -3.17347 6.37497 +352 1 3.55123 4.20329 5.82208 -22.8323 -11.992 0.86056 +353 1 5.31479 3.43328 4.96004 -12.842 -18.3451 -4.95866 +354 1 5.96487 4.21664 4.98586 3.26728 12.2832 1.14917 +355 1 5.67633 3.58987 5.96581 6.91479 -13.8012 -0.0730494 +356 1 5.15168 4.48521 5.88819 -0.135174 -6.62981 7.61527 +357 1 6.76571 3.37692 5.24691 -14.8051 -2.47074 -4.50431 +358 1 7.42413 4.19524 5.01259 2.27671 4.46784 -0.576517 +359 1 7.6092 3.42318 5.84837 11.8264 -15.8262 -18.7291 +360 1 6.54398 4.29611 5.89957 10.509 -8.9195 -1.16059 +361 1 0.0247094 4.83566 4.99938 1.36656 0.603431 -2.15766 +362 1 0.966205 6.14847 4.9405 -1.84638 -2.56131 10.6129 +363 1 1.10739 5.11215 5.5368 -2.77114 7.32267 -6.17701 +364 1 0.221311 5.77966 5.62316 -16.3542 -5.99991 -34.5248 +365 1 2.09075 4.80339 4.88071 -15.5377 1.88455 -3.51044 +366 1 2.76626 5.59872 5.00497 -13.1053 -0.333159 -40.3797 +367 1 2.60002 4.95633 5.81939 -13.3057 -3.60712 -16.1699 +368 1 1.73302 6.11974 5.67311 7.80367 -13.5214 9.39307 +369 1 3.69174 5.11983 4.8182 4.27828 -13.6521 -3.16237 +370 1 4.24517 5.95869 5.19837 -53.2876 -10.1225 40.5156 +371 1 4.22774 4.94663 5.7496 8.19104 22.5118 -1.663 +372 1 3.1136 6.02947 5.80151 37.6339 -12.4217 36.265 +373 1 5.23537 5.12533 5.07481 2.14794 5.35663 -5.58383 +374 1 5.80775 6.19434 5.36474 -12.1517 -18.4331 -19.8184 +375 1 5.9697 5.18437 6.0003 -7.47906 6.99384 0.912527 +376 1 4.94854 5.8692 5.99559 17.5377 -1.26338 -12.9619 +377 1 6.59757 5.09144 5.08104 3.06742 4.08464 -2.92894 +378 1 7.54367 5.98613 4.88573 -14.2361 -23.7654 7.79426 +379 1 7.60847 5.23322 5.63185 -1.35187 -6.94343 4.2911 +380 1 6.70769 5.94816 5.81677 14.1283 2.13907 3.81564 +381 1 8.22278 6.71702 5.01662 22.4316 17.1972 -3.51396 +382 1 0.869349 7.28869 4.96667 -10.0366 3.62496 3.89926 +383 1 0.896793 6.73687 5.91431 -6.40765 3.74255 3.0528 +384 1 0.0890555 7.7054 5.6706 -5.18167 -47.9244 34.8448 +385 1 1.8751 6.88564 4.94229 0.477268 -2.00274 -5.71819 +386 1 2.7587 7.55291 4.99872 -36.0591 6.05211 43.0833 +387 1 2.53846 6.82983 5.7787 -13.9577 26.1772 12.6196 +388 1 1.63934 7.57104 5.79621 -1.51722 -4.07644 10.4552 +389 1 3.46612 6.83867 5.20388 -3.25728 -8.15264 -25.1259 +390 1 4.01792 7.77747 5.13143 8.22604 -9.98488 -11.0207 +391 1 4.0616 6.71165 5.99374 37.4635 -34.7522 2.57336 +392 1 3.49035 7.48383 6.06615 -52.3442 43.3465 -6.60384 +393 1 4.82693 6.8523 5.20763 2.69445 10.0085 20.3981 +394 1 5.83663 7.67662 4.94011 2.65651 0.782445 -0.458959 +395 1 5.60118 6.903 6.05259 0.51238 5.45548 -5.22943 +396 1 4.49984 7.67391 6.05154 31.0401 -0.647522 -9.371 +397 1 6.56806 6.92617 5.22736 4.49918 -20.7724 -24.6194 +398 1 7.45007 7.68748 5.02454 6.13987 -21.0163 7.77973 +399 1 7.49751 6.80367 5.78308 -9.98894 13.1501 -5.7166 +400 1 6.63057 7.61754 5.92417 0.0687578 21.3795 23.8905 +401 1 8.32557 8.34894 6.68981 0.104638 -13.8897 -9.6087 +402 1 0.744366 0.980723 6.48852 -5.23114 -31.7269 30.0044 +403 1 1.21108 0.262565 7.55604 -5.48851 -4.18087 -6.76609 +404 1 8.40118 0.701811 7.40569 17.4537 3.62996 11.6339 +405 1 1.79336 8.32699 6.64062 -5.93242 0.737609 -0.84307 +406 1 2.60519 1.4776 6.42908 -42.7477 -20.3947 10.8513 +407 1 2.68468 8.32969 7.50367 2.82039 -8.74718 0.911275 +408 1 2.14004 0.776947 7.26895 -3.65906 16.1309 -1.11008 +409 1 3.6569 0.0715803 6.70451 13.9675 -20.3473 29.1568 +410 1 3.94985 1.1248 6.78323 8.0083 0.919865 -1.94163 +411 1 4.44955 0.15543 7.5921 -15.5929 3.09145 7.2634 +412 1 3.18676 1.19789 7.55079 30.4701 -36.3009 -8.08868 +413 1 5.10396 0.131358 6.81912 -7.97923 37.9971 -21.1894 +414 1 5.81993 0.996314 6.79068 7.76858 -21.7284 -2.73997 +415 1 5.80025 8.18188 7.49322 12.3507 -13.1302 8.70784 +416 1 4.85408 1.28227 7.42764 -12.4579 -6.47968 -9.5274 +417 1 6.58875 0.130914 6.74241 2.12753 -2.2097 0.634037 +418 1 7.59964 0.676617 6.71682 -68.3673 2.07925 42.2066 +419 1 7.52212 0.0593286 7.5834 32.5631 3.04014 -28.8024 +420 1 6.85279 0.923554 7.57208 -4.28539 1.49265 -2.17621 +421 1 8.34941 1.72633 6.6429 -6.24486 10.7883 12.2426 +422 1 0.752277 2.47155 6.72526 -3.9412 -10.7788 3.00465 +423 1 0.813192 1.63555 7.42993 -7.74314 -11.2011 -0.638694 +424 1 8.22443 2.54813 7.66732 2.56273 -1.56785 0.82339 +425 1 1.49636 1.56107 6.38447 44.5625 33.4582 -3.13704 +426 1 2.30525 2.475 6.76961 -5.35408 6.54562 -0.949005 +427 1 2.49056 1.84724 7.59513 -61.407 9.30511 10.8314 +428 1 1.49273 2.39823 7.65033 13.5773 11.0727 -11.0854 +429 1 3.37689 2.03992 6.64219 17.5424 18.1797 1.52712 +430 1 4.36556 2.35363 6.72974 2.65202 20.8248 17.9478 +431 1 3.99822 2.02063 7.6547 18.3091 -10.0739 6.1027 +432 1 3.17328 2.55424 7.53823 -10.8617 31.8229 -4.73645 +433 1 5.21112 1.76508 6.50479 -18.4173 6.52495 3.64931 +434 1 5.87572 2.50861 6.47972 17.6588 16.4017 11.3405 +435 1 6.13161 1.75643 7.42519 -6.35346 6.11936 8.80778 +436 1 5.08243 2.27965 7.49559 3.10695 14.763 0.591819 +437 1 6.90515 1.73737 6.69685 6.36969 -4.89015 -2.67266 +438 1 7.59965 2.63279 6.71489 9.55617 -0.301288 -8.47778 +439 1 7.76189 1.52013 7.52701 3.93719 -1.66085 -6.19761 +440 1 6.70724 2.6779 7.2598 -8.99322 4.2321 11.9078 +441 1 0.125444 3.31521 6.66881 -20.5423 -11.9528 1.08126 +442 1 0.364694 4.22273 7.06 15.4688 8.78987 -5.27721 +443 1 0.60791 3.34758 7.65433 9.81501 -30.9601 -14.2913 +444 1 8.0984 3.85412 7.73406 0.295867 21.4592 0.238003 +445 1 1.38869 3.28611 6.86269 8.50148 8.2104 -0.813622 +446 1 2.52476 4.25334 6.66316 13.9982 13.4488 20.9739 +447 1 2.34408 3.26799 7.64808 -1.14502 9.26403 -10.1755 +448 1 1.45935 4.43411 7.31503 0.0272838 -0.538431 -2.52173 +449 1 3.66593 3.34626 6.65797 -1.50742 -4.19973 -15.7128 +450 1 4.32339 4.28741 6.63848 -1.71153 0.00989822 -0.270268 +451 1 4.03917 3.1404 7.61252 24.7136 -10.2891 3.12208 +452 1 3.36907 3.93473 7.50701 -10.481 -0.383957 -6.9951 +453 1 4.88527 3.3354 6.73465 -0.250758 1.18323 3.20962 +454 1 5.86197 4.30684 6.74144 -6.02175 10.4775 -12.9313 +455 1 5.83143 3.4729 7.33725 -5.24712 -23.3614 7.27214 +456 1 5.04517 4.19893 7.47372 14.0277 -13.7659 1.86079 +457 1 6.67093 3.19494 6.32389 -1.08882 16.2366 5.3564 +458 1 7.58567 3.93824 6.68879 13.8607 17.9546 17.9945 +459 1 7.41034 3.22296 8.01852 -22.7502 -28.7124 0.282368 +460 1 6.74041 3.98357 7.25541 -1.38378 3.03134 11.4432 +461 1 8.11164 5.05821 6.64701 -10.3621 4.23498 3.48281 +462 1 0.434229 5.95598 6.55583 13.6324 -1.56553 39.6492 +463 1 0.429061 5.17903 7.41995 -0.29478 -7.71855 -15.5486 +464 1 8.09598 5.94892 7.38464 -0.670206 -2.17368 6.38869 +465 1 1.41611 5.29567 6.55129 0.191903 6.07763 6.12613 +466 1 2.44376 5.87825 6.63669 -4.18767 0.226771 1.1996 +467 1 2.57445 4.71437 7.62895 -9.06207 26.6712 -23.195 +468 1 1.76163 5.67875 7.56712 4.16416 -0.382203 -1.94173 +469 1 3.23562 5.1121 6.55719 20.8924 -0.347412 22.4145 +470 1 4.05367 5.80831 6.49809 -13.6658 -13.8236 9.34588 +471 1 4.3499 4.91428 7.57309 -17.8958 19.2373 1.53594 +472 1 3.33848 5.81136 8.0112 0.629066 -2.48199 -2.55986 +473 1 5.22933 5.24678 6.83002 -9.21161 -10.3226 -4.65561 +474 1 5.87231 6.12998 6.73434 -14.492 -21.708 -7.10976 +475 1 6.102 5.06631 7.42095 8.16162 7.57706 8.09799 +476 1 5.11386 5.85851 7.69037 1.37823 -1.01778 -7.91082 +477 1 6.94866 5.10876 6.52261 -0.00645701 0.734687 4.76591 +478 1 7.67078 6.01392 6.41167 -4.02477 -14.728 2.57416 +479 1 7.35061 4.96205 7.5433 24.0095 -18.1944 -20.4412 +480 1 6.9284 5.83495 7.63045 -18.4707 37.5628 2.3937 +481 1 8.28984 6.85999 6.50497 12.0319 11.2505 5.01489 +482 1 0.775248 7.71516 6.80461 7.24585 -11.6558 8.08417 +483 1 0.533688 6.7762 7.54365 3.89137 -4.31915 -15.8578 +484 1 8.2465 7.61079 7.46416 25.9419 0.696332 -26.8887 +485 1 1.73177 6.71435 6.78434 -8.61422 -0.737705 -7.23833 +486 1 2.48272 7.50206 6.80041 12.0152 -3.31551 -7.82219 +487 1 2.37093 6.72113 7.64339 9.62293 -9.48685 2.94166 +488 1 1.77272 7.59226 7.58949 -2.97267 7.70343 0.621675 +489 1 3.29197 6.66554 6.74519 -6.55378 -4.76021 6.1499 +490 1 4.04728 7.44441 6.9325 9.38301 -4.09453 15.5296 +491 1 4.12674 6.55075 7.78018 3.09461 4.03017 -1.80654 +492 1 3.3807 7.43243 7.7243 -9.78058 -0.600287 9.7772 +493 1 4.74428 6.55735 6.78071 12.1641 10.0813 15.0085 +494 1 5.30209 7.56833 6.75011 8.90694 -20.2013 0.20059 +495 1 5.88783 6.83008 7.50111 -3.28565 3.55282 5.18781 +496 1 4.85536 7.429 7.66393 -0.8844 -0.824359 14.1315 +497 1 6.78323 6.58213 6.75112 16.4005 10.5566 0.00129152 +498 1 7.49771 7.53891 6.69245 -0.0692693 6.11315 -11.5276 +499 1 7.61589 6.80831 7.76686 -5.70997 -4.77696 -9.529 +500 1 6.80731 7.4637 7.45575 -10.489 5.43873 12.05 +ITEM: TIMESTEP +200 +ITEM: NUMBER OF ATOMS +500 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +ITEM: ATOMS id type x y z f_2[1] f_2[2] f_2[3] +1 1 8.41242 8.26599 8.38785 -10.0358 6.58437 5.2801 +2 1 0.814162 0.710931 0.0523899 -37.3452 31.5986 3.80166 +3 1 0.707188 8.3394 0.783901 7.22527 -6.84977 10.4166 +4 1 0.078844 0.75192 1.11978 38.2878 -8.01586 -1.83777 +5 1 1.52052 0.0613493 8.33894 50.642 -18.5757 54.2409 +6 1 2.63022 0.777198 -0.0136511 -14.6872 26.2087 -8.24369 +7 1 2.86573 8.3667 0.519039 4.98442 -20.5506 12.9041 +8 1 1.4757 0.711348 0.992341 22.4024 -8.05229 -33.8354 +9 1 3.79318 8.20698 8.14977 -12.6173 11.8638 7.05406 +10 1 4.0381 1.06879 8.36154 -11.3644 -3.77089 -31.1235 +11 1 3.94622 0.00241404 0.83531 3.0713 5.57971 3.39388 +12 1 3.2904 1.19609 0.697286 11.5663 -9.90219 11.4209 +13 1 4.80931 8.28217 0.152557 1.5084 -10.3853 -19.3359 +14 1 5.59181 0.724855 8.1093 -26.5323 12.4899 -7.60558 +15 1 5.68752 0.120676 0.713607 11.3113 1.42738 1.49966 +16 1 4.78554 0.81043 0.585131 26.0655 -22.1296 9.76004 +17 1 6.43613 0.237453 8.26775 30.1844 -14.2258 6.08634 +18 1 7.5043 0.643436 0.0691857 2.69659 0.617275 -0.831401 +19 1 7.7682 0.0476766 1.0238 2.88283 -8.74262 5.4154 +20 1 6.83111 0.459822 0.931748 -10.2254 10.6222 -23.4955 +21 1 0.00401405 1.51379 8.26626 1.73444 -9.97848 2.73777 +22 1 0.631563 2.29056 0.214422 2.30445 -4.73927 -16.4851 +23 1 0.869727 1.5347 0.919411 -20.3113 -10.6479 -1.82401 +24 1 -0.0840974 2.27001 1.15035 26.4165 13.702 -18.8298 +25 1 1.67911 1.38813 0.0883733 4.29152 4.16945 3.72554 +26 1 2.34463 2.397 8.3967 -0.661743 10.3894 16.138 +27 1 2.41792 1.69378 0.837891 -11.9994 8.17272 5.13712 +28 1 1.50784 2.3296 0.8821 15.8347 5.46342 -6.24169 +29 1 3.19181 1.77289 8.14083 -8.92279 -4.86777 22.8625 +30 1 4.12817 2.46218 8.33741 8.13153 -11.9637 0.536015 +31 1 4.26337 1.62555 0.809789 -13.061 44.2943 -8.13534 +32 1 3.42316 2.33556 0.802814 -4.29938 0.254861 -1.13643 +33 1 5.0669 1.62594 8.33933 -4.47953 5.08137 -8.2197 +34 1 5.91213 2.40952 0.124369 -13.9 -26.0969 3.99436 +35 1 6.23275 1.281 0.442008 -1.76602 1.09435 0.219677 +36 1 5.05785 2.29128 0.753897 1.63462 9.40663 2.64296 +37 1 6.76196 1.99075 8.08873 7.25593 -6.72787 12.2575 +38 1 7.89568 2.35083 0.217856 -14.3986 10.074 -11.1844 +39 1 7.7557 1.40697 0.992421 -28.0785 15.2332 -13.5573 +40 1 6.69672 2.20109 0.984157 0.465363 17.7913 -13.2761 +41 1 8.2159 3.42858 0.185567 12.3977 0.764361 -3.90376 +42 1 0.927092 4.2442 8.41258 -26.45 -26.3493 -4.33489 +43 1 0.729094 3.09987 0.813639 -4.58702 16.175 15.6607 +44 1 0.0788068 4.49033 1.02182 1.48174 1.40892 2.78463 +45 1 1.55842 3.1508 0.126599 -1.73889 6.5262 3.04002 +46 1 2.29185 4.09245 0.0493365 -0.242842 -5.39025 -0.756334 +47 1 2.41785 3.22623 0.89121 8.0106 -0.183268 -6.38994 +48 1 1.56843 4.03679 0.931375 1.76309 0.26565 -2.14494 +49 1 3.4359 3.23233 0.0225532 -4.36687 10.8322 6.25926 +50 1 4.25669 4.07361 0.0880133 2.8279 3.66932 -9.72921 +51 1 4.34048 3.08558 0.785495 -4.69141 6.70607 0.15029 +52 1 3.59299 3.90329 0.886528 -10.5717 12.5753 -2.99495 +53 1 5.13064 3.04982 8.22833 -0.225212 8.61676 17.0697 +54 1 5.81502 4.09178 8.38841 -21.2737 -2.05468 -24.8502 +55 1 5.97613 3.1773 0.894798 -5.61602 -19.9636 -19.3342 +56 1 5.09497 3.91821 0.747666 0.511602 -0.648627 8.1507 +57 1 6.51767 3.18724 8.3864 17.647 23.2966 -13.5196 +58 1 7.37164 4.03522 8.29689 -11.4262 -6.53116 -1.21962 +59 1 7.31211 3.24078 0.704535 -4.3132 -0.596821 4.84194 +60 1 6.56447 4.1734 0.602333 27.4745 -11.0091 36.7473 +61 1 8.15631 4.68203 0.075112 10.7012 -10.9934 -7.99724 +62 1 1.11663 5.88929 8.3609 -7.93077 -20.1145 9.26986 +63 1 0.996074 4.97243 1.21409 -6.72433 0.768332 -3.74364 +64 1 0.189403 5.66667 0.913187 -7.3538 -1.57168 -7.21317 +65 1 1.58163 4.94764 0.201022 19.1991 11.3216 -0.454803 +66 1 2.29237 5.73911 0.0748948 8.80602 19.0835 -4.47029 +67 1 2.49097 4.65203 0.981363 3.25616 8.72811 -9.97843 +68 1 1.87095 5.55306 0.995907 1.03553 19.7133 11.0025 +69 1 3.18407 5.012 0.131558 5.578 6.2636 9.58863 +70 1 4.09719 5.68255 0.132658 4.03261 5.63654 -2.85988 +71 1 4.12395 4.88832 0.852082 2.34539 -1.75572 -18.9743 +72 1 3.07234 5.70133 0.969327 -0.346407 5.49919 1.56796 +73 1 5.11274 5.00399 0.171908 -9.99815 3.39538 19.3609 +74 1 5.76656 5.80521 0.11529 9.4035 3.26414 21.2303 +75 1 6.01079 5.05469 0.873922 -27.3446 -31.3954 -10.6646 +76 1 4.89913 5.95208 0.960158 8.00863 4.38535 -8.86024 +77 1 6.75863 4.93475 8.31779 -18.6284 14.8779 13.2188 +78 1 7.8245 5.62001 8.34465 11.2383 14.3374 0.909184 +79 1 7.51856 5.31135 0.853265 4.91639 -9.6583 11.5193 +80 1 6.62461 5.81662 0.841147 8.94471 25.6435 -17.3923 +81 1 0.202013 6.46046 8.33455 0.0609498 5.25542 6.45446 +82 1 0.889578 7.53674 8.33221 1.62686 -1.40391 0.0530776 +83 1 0.953366 6.38848 0.908196 -1.46223 4.85455 -5.86941 +84 1 0.145952 7.39993 0.791819 5.48829 -5.75958 -9.51465 +85 1 1.67676 6.71324 8.36121 2.78795 2.25277 6.97945 +86 1 2.21164 7.54618 8.16806 16.5579 9.64776 9.50482 +87 1 2.40278 6.62803 0.856512 -0.674903 -8.3487 -4.56859 +88 1 1.53782 7.38975 0.90846 -3.10291 8.8481 -14.5459 +89 1 3.27325 6.398 0.0420856 1.14847 -3.14438 14.8868 +90 1 4.24204 7.28724 8.33928 2.62398 3.89094 44.6004 +91 1 4.04999 6.6211 0.862788 13.5756 -10.8829 -5.05866 +92 1 3.45704 7.41684 0.605416 -19.3758 10.5723 4.19592 +93 1 5.13383 6.59732 8.2884 -30.4967 14.0841 16.2852 +94 1 5.83566 7.60311 0.0824633 -14.5596 3.16754 7.91958 +95 1 5.71227 6.86684 0.81732 11.5827 -10.7391 -7.91805 +96 1 4.90381 7.61313 0.94797 9.27737 -4.87268 -6.49352 +97 1 6.72722 6.86314 0.253587 -5.2734 -0.113759 -0.620065 +98 1 7.41232 7.77996 0.331703 18.857 -4.07135 -25.363 +99 1 7.56998 6.39348 0.735875 7.28329 1.56003 -0.789213 +100 1 6.66601 7.84216 0.965777 -32.1881 -17.8038 12.8266 +101 1 0.166766 -0.00131261 1.94063 8.32296 1.94608 -3.28266 +102 1 0.934833 0.817938 1.81275 -21.8629 -14.287 17.2076 +103 1 1.00207 0.316008 2.82556 -21.807 -5.91521 -4.01431 +104 1 8.35945 0.74 2.72116 2.32177 4.37751 -0.902675 +105 1 1.48465 8.25372 1.60749 -1.18562 -7.12983 8.20441 +106 1 2.44318 0.774258 1.4766 5.48942 -2.99924 2.57908 +107 1 2.3069 8.18025 2.36522 1.41087 2.4731 2.95424 +108 1 1.85775 0.858752 2.6061 9.12182 6.5265 -4.79678 +109 1 3.23269 0.0488049 1.82801 0.784922 27.4455 -30.2613 +110 1 4.21175 0.99942 1.57195 -9.49462 -27.3711 22.4225 +111 1 4.21293 0.25409 2.38861 -7.75181 -9.25535 -4.23311 +112 1 3.32934 0.964581 2.65137 -6.01516 -9.0041 -1.19732 +113 1 4.9787 0.193499 1.50831 -4.98755 -8.3429 -3.28083 +114 1 6.09517 0.531101 1.76326 -28.5995 19.6806 -10.71 +115 1 5.85753 8.23852 2.51303 -1.20503 -8.99564 8.87124 +116 1 5.17785 0.685106 2.40543 -1.30449 11.3507 4.36005 +117 1 6.91213 8.37413 1.83271 8.62238 -24.2277 10.2354 +118 1 7.62368 0.758482 1.85178 16.0234 8.8439 -5.1341 +119 1 7.66132 8.34118 2.51601 5.03438 -8.87196 18.1761 +120 1 6.82917 0.875718 2.51872 -7.12717 1.70889 8.15245 +121 1 0.0949053 1.53257 1.83348 -15.8355 -28.5862 13.9628 +122 1 0.822415 2.21502 1.73119 16.0449 19.2167 -17.682 +123 1 0.864878 1.50475 2.57372 12.4143 -0.0682656 8.67505 +124 1 0.199844 2.34986 2.54349 -13.4424 7.82132 10.7389 +125 1 1.68463 1.52556 1.71378 7.71699 13.5023 1.83995 +126 1 2.69369 2.59616 1.91546 -20.6965 -6.26723 -3.29779 +127 1 2.60471 1.76603 2.62425 -5.19989 2.78858 2.334 +128 1 1.44056 2.43723 2.51936 11.6798 4.82752 9.65183 +129 1 3.43446 1.65477 1.84942 -9.01773 7.52097 -5.37653 +130 1 4.19061 2.39179 1.65045 11.7616 -7.21515 -2.54075 +131 1 4.26672 1.39737 2.67586 10.1937 6.39563 -7.12371 +132 1 3.53921 2.577 2.549 6.10272 -3.10086 8.1996 +133 1 5.17395 1.33784 1.40963 0.810412 -15.8822 3.29742 +134 1 5.74074 2.13809 1.54869 21.9361 25.9957 -3.59082 +135 1 5.9363 1.515 2.34901 -9.46258 -12.7333 10.9894 +136 1 4.95982 2.19781 2.39856 0.709797 0.431383 -4.3853 +137 1 6.78917 1.32128 1.47071 -5.63197 2.68115 20.8841 +138 1 7.62581 2.16504 1.87345 17.6788 -6.34038 -2.38007 +139 1 7.68847 1.62015 2.88771 -1.999 -29.1097 -18.0204 +140 1 6.72066 2.18015 2.22288 -25.5596 -3.13399 14.9826 +141 1 8.10556 3.24278 1.47587 8.10057 -1.81275 -31.7951 +142 1 0.698788 3.89936 1.58833 21.0059 -8.7854 2.84332 +143 1 0.726156 3.39424 2.59236 2.18368 -0.846434 0.375997 +144 1 8.21488 4.03893 2.09204 -9.31366 21.6556 21.1016 +145 1 1.61294 3.13444 1.56982 -6.75222 2.4564 11.7453 +146 1 2.47309 3.97186 1.76449 2.21347 -7.98753 7.5428 +147 1 2.67292 3.22702 2.95068 5.54423 5.59107 -13.8219 +148 1 1.72826 4.2557 2.53344 -3.42962 -20.862 21.8798 +149 1 3.48214 3.13902 1.56572 3.70104 11.9942 4.11222 +150 1 4.3885 3.8788 1.62665 2.95307 16.2819 -22.5535 +151 1 4.3065 3.38859 2.48531 -9.81397 -19.0665 24.4754 +152 1 3.47101 4.13314 2.35987 0.052847 -5.96917 4.43729 +153 1 5.11162 3.02695 1.57487 -2.09605 4.71156 2.60925 +154 1 6.05823 3.77666 1.6683 -0.0795953 27.02 22.5131 +155 1 5.89604 2.8633 2.33341 1.61726 0.0933652 1.12851 +156 1 5.29152 3.73349 2.43504 2.35223 15.5067 -10.4051 +157 1 6.82698 3.04592 1.66447 4.37333 2.796 -3.08497 +158 1 7.47158 4.33914 1.21316 -2.11938 -7.51647 -10.9268 +159 1 7.68828 3.1018 2.37066 -8.14673 6.79824 16.7729 +160 1 7.09384 4.0081 2.08909 -5.93874 -19.0069 4.73504 +161 1 8.1255 5.22391 1.77055 19.2122 -25.3413 6.96334 +162 1 0.62612 5.90176 1.99772 9.96713 -14.5554 -17.3464 +163 1 0.76801 4.79289 2.36504 -2.78355 1.48316 -1.85895 +164 1 8.18318 5.95034 2.62286 5.26633 -16.349 1.23379 +165 1 1.81648 4.94963 1.84319 1.29255 4.07737 -28.8924 +166 1 2.40619 6.07189 1.89723 9.11627 0.0929027 -31.5253 +167 1 2.58707 5.01704 2.50938 -14.4694 3.44726 -14.5204 +168 1 1.72272 5.71364 2.51972 -25.0056 3.38939 29.4203 +169 1 3.42498 4.85355 1.57173 -14.1697 1.2804 16.3608 +170 1 4.15303 5.79502 1.71807 -6.58651 -0.238746 -3.12281 +171 1 4.46167 4.86212 2.18786 -1.52672 -11.6836 -0.120829 +172 1 3.29589 5.94757 2.4039 5.86702 -13.0661 19.8541 +173 1 5.03295 4.96131 1.30642 14.6935 -5.33684 5.62219 +174 1 5.82775 5.80433 1.62537 -3.48018 5.04048 -3.36734 +175 1 5.79583 4.80394 2.11298 -5.34853 -5.63002 0.159279 +176 1 5.01708 6.04912 2.32216 17.4276 -29.4439 17.4564 +177 1 6.71539 5.10912 1.63093 10.3915 -7.52696 11.1074 +178 1 7.41693 5.91425 1.78268 -24.8131 17.7871 4.30264 +179 1 7.12646 4.86445 2.63426 13.6393 21.9613 3.08537 +180 1 6.42336 6.18201 2.43584 15.1603 10.9548 -7.96948 +181 1 8.23881 6.55347 1.60468 9.12903 0.565206 1.23333 +182 1 0.678624 7.37322 1.88745 -5.46988 3.49615 -25.4292 +183 1 0.794621 6.6529 2.67297 0.0873755 -1.33888 6.26964 +184 1 8.30959 7.39568 2.5723 10.9372 15.1486 20.2523 +185 1 1.53592 6.72715 1.69313 10.3025 -8.32698 21.6565 +186 1 2.52873 7.48993 1.45805 2.51224 9.72508 0.958573 +187 1 2.57516 6.97533 2.39376 0.331622 5.62636 7.11361 +188 1 1.48127 7.49186 2.513 25.359 1.87736 0.862705 +189 1 3.42472 6.67917 1.69715 -9.14691 10.5288 -4.39359 +190 1 4.07864 7.56162 1.54537 -20.7523 -1.21573 5.0956 +191 1 4.22077 6.65705 2.50099 -12.9989 13.269 2.80638 +192 1 3.32476 7.76609 2.51834 12.0821 -31.6775 22.1813 +193 1 5.18316 6.78911 1.6853 -16.2098 8.5059 -12.8052 +194 1 5.76367 7.66024 1.61411 8.21393 8.40414 -2.16429 +195 1 5.72928 6.97443 2.55641 -4.2085 8.68736 -3.41382 +196 1 4.81509 7.65411 2.27112 9.64741 4.31731 11.3389 +197 1 6.71673 6.6577 1.40921 -4.23135 13.1654 3.72162 +198 1 7.9523 7.57862 1.62003 -19.0505 2.7611 2.11499 +199 1 7.55182 6.74669 2.5625 -26.4699 -4.16644 -1.81267 +200 1 6.71006 7.32273 2.23599 -2.19037 10.3011 3.68982 +201 1 8.3209 8.25724 3.44082 -11.2006 13.9316 -31.0885 +202 1 1.1383 0.707726 3.88488 2.87074 16.2111 -29.5751 +203 1 0.710637 8.17953 4.00977 26.7141 2.01724 45.2521 +204 1 0.017483 0.84611 4.17688 -4.01486 -16.4278 3.15279 +205 1 1.83485 0.022043 3.36625 6.99225 9.16158 -10.2142 +206 1 2.5734 1.02544 3.4638 -2.67645 -0.861554 5.53773 +207 1 2.46831 8.35234 4.18841 -8.88118 2.57467 1.82808 +208 1 1.9704 0.882634 4.50547 -3.01692 -0.258051 -7.68015 +209 1 3.15194 0.11929 3.26603 1.99843 -0.203753 6.521 +210 1 4.16362 0.594977 3.39201 1.91533 3.30238 12.0146 +211 1 4.48096 8.3197 4.27248 -34.7907 27.9025 -6.28307 +212 1 3.49096 0.991035 4.39487 -18.0924 -11.2469 -3.89782 +213 1 5.15221 8.33246 3.40287 -4.49662 4.44033 -5.3065 +214 1 5.83668 0.780008 3.22544 8.18869 5.41063 4.37051 +215 1 5.71056 8.31473 4.3397 -0.683085 13.1798 -1.88784 +216 1 5.01734 0.796017 4.33297 -1.83196 10.7479 -11.7081 +217 1 6.55531 0.0226915 3.33292 8.64001 -7.40459 4.85944 +218 1 7.40254 0.734891 3.44283 9.92215 2.2266 -9.49047 +219 1 7.60175 8.41313 4.17692 -11.7492 9.12522 14.6015 +220 1 6.69717 0.884026 4.20434 -2.52907 -5.48675 3.38708 +221 1 0.266587 1.50956 3.42506 -7.49445 4.66836 1.70669 +222 1 0.834612 2.3929 3.4535 3.19311 14.9998 -2.79098 +223 1 0.966342 1.70753 4.27772 -2.38166 -3.63555 7.29451 +224 1 8.31528 2.54359 4.03878 16.7451 -1.36482 20.306 +225 1 1.65675 1.69619 3.39484 3.12529 -6.34044 -1.62009 +226 1 2.21998 2.62053 3.66497 -8.94713 -4.89956 5.05059 +227 1 2.70158 1.84855 4.22365 -4.21065 -7.00328 -1.279 +228 1 1.73069 2.39291 4.69998 -11.0397 -15.2385 -11.7518 +229 1 3.63597 1.81901 3.49635 -5.37102 -6.0004 0.428615 +230 1 4.5181 2.45307 3.50704 1.92291 5.38714 1.37796 +231 1 4.28022 1.61295 4.532 11.684 13.523 -0.759472 +232 1 3.49161 2.67545 4.21356 3.70186 4.50981 -2.53687 +233 1 5.05676 1.45985 3.45113 -18.7528 -7.6908 -2.02124 +234 1 5.59639 2.31007 3.23954 13.071 6.11501 -14.1907 +235 1 5.90515 1.58558 4.07201 2.34854 -1.44676 5.83562 +236 1 5.6448 2.61062 4.20904 5.92031 11.7583 11.4648 +237 1 6.60245 1.81532 3.22394 -0.344578 -17.0844 -10.2298 +238 1 7.7209 2.5366 3.23021 -13.9757 26.3091 7.5372 +239 1 7.59991 1.69339 4.17685 -3.31209 -2.6982 -2.62135 +240 1 6.7571 2.48096 3.97019 3.90879 12.298 15.8753 +241 1 8.32132 3.59836 3.32434 15.1974 -18.6025 -8.65377 +242 1 0.758776 4.28533 3.41911 8.12571 10.2206 -6.43372 +243 1 0.714283 3.43939 4.05789 10.8012 -17.4951 -4.32355 +244 1 8.37038 4.20103 4.16336 -19.0683 10.428 -9.16118 +245 1 1.7111 3.58985 3.37102 -4.50013 -9.39619 -9.22108 +246 1 2.7295 4.29586 3.34058 -27.7709 -28.5377 3.76594 +247 1 2.75779 3.49033 4.0215 3.07014 12.8072 -10.7423 +248 1 1.81597 4.04867 4.27403 8.34757 5.06165 3.43123 +249 1 3.63217 3.50284 3.43026 7.64322 -9.23013 -17.5251 +250 1 4.42979 4.3957 3.21235 -5.21891 -3.02116 0.669719 +251 1 4.46277 3.52681 4.13413 -5.3566 -4.51807 -16.5208 +252 1 3.52987 4.30614 4.06609 5.60483 14.7001 10.5939 +253 1 5.31574 3.44078 3.42467 1.48508 -5.70873 13.1076 +254 1 6.44336 4.14284 2.93215 -36.0911 1.99853 0.657603 +255 1 6.52296 3.60341 4.02819 -0.573509 -3.99567 -1.18998 +256 1 5.23388 4.48156 3.97453 6.55779 -4.33302 -0.590571 +257 1 6.75544 3.08581 2.98548 -20.753 -29.7898 -6.93237 +258 1 7.36113 3.83069 3.18965 17.3707 23.8596 11.1094 +259 1 7.68707 3.36428 4.36221 -8.90323 13.3285 -23.8114 +260 1 6.58157 4.70256 3.96292 -12.6487 -1.89838 -2.64764 +261 1 8.03895 4.72186 3.2072 7.03567 0.390199 -0.150374 +262 1 0.641986 5.57832 3.32415 -3.93783 9.97933 -29.9316 +263 1 0.748525 5.2954 4.26917 10.3198 11.1143 16.7142 +264 1 8.33552 6.07931 4.24855 1.05812 -13.5964 19.1647 +265 1 1.90145 4.96491 3.42288 -7.34814 1.12325 1.52157 +266 1 2.61408 5.80343 3.49254 4.58835 0.11833 -14.0758 +267 1 2.80014 5.15473 4.32615 -31.6367 11.9713 -55.3412 +268 1 1.9564 6.07585 4.27618 -9.91164 -20.8823 -47.0179 +269 1 3.37946 4.96765 3.07865 55.664 27.3093 14.9143 +270 1 4.23608 5.59453 2.88525 -18.9133 13.1689 8.33969 +271 1 4.44604 5.19737 4.14454 -7.57666 -13.265 -14.5347 +272 1 3.6416 5.84891 3.83409 2.65328 -4.22633 -4.19185 +273 1 5.15151 5.25659 3.1676 14.0924 -4.2121 3.02426 +274 1 5.82306 6.30397 3.36345 -4.54273 -6.47443 0.566248 +275 1 5.74908 5.5163 4.09569 25.3818 -3.33304 -26.8083 +276 1 4.83867 6.14359 3.79115 -4.65662 -0.583485 3.38738 +277 1 6.22614 5.32285 2.95137 -4.13422 -8.32687 15.6358 +278 1 7.32122 5.97196 3.33835 -0.00434101 -1.28454 -1.88403 +279 1 7.49659 5.17369 4.09183 8.55988 6.64783 3.63555 +280 1 6.75151 6.22479 4.25773 -16.211 -27.6787 -10.8075 +281 1 8.29215 6.64155 3.42114 5.59717 18.8581 -19.6047 +282 1 0.763473 7.56557 3.23404 -12.9198 -1.64007 -15.2341 +283 1 1.0031 6.68313 3.72439 -4.3972 -14.7662 15.3222 +284 1 8.23363 7.61771 4.35977 7.30279 -9.1197 2.90547 +285 1 1.95141 6.6466 3.21786 0.736159 0.439247 -2.07076 +286 1 2.6385 7.59536 3.37124 -4.27783 -4.21174 -0.733124 +287 1 3.13092 6.60025 4.41497 -19.4938 11.5887 -14.0245 +288 1 1.65818 7.53719 3.85187 -1.11019 -9.22082 13.1065 +289 1 3.27775 6.71474 3.27823 1.67015 1.07042 -3.65835 +290 1 4.1525 7.8844 3.3351 -7.70608 -2.7891 -4.06245 +291 1 3.98551 7.08252 4.24517 31.7093 2.51435 -5.83578 +292 1 3.40048 7.93533 4.31596 7.03572 3.0716 -3.37554 +293 1 4.94636 7.13355 3.35885 -28.0161 -11.5072 -5.66389 +294 1 5.84413 7.52046 3.45751 31.3517 19.8289 8.4284 +295 1 5.90459 6.85513 4.30093 -7.30307 7.57049 -1.80424 +296 1 5.01344 7.53745 4.4217 23.0153 -42.676 2.37557 +297 1 6.69892 6.88846 3.31402 6.29068 2.24472 -2.02408 +298 1 7.47533 7.68601 3.37673 -12.6934 -11.1052 -3.87233 +299 1 7.49921 6.86202 4.09322 12.1924 13.0141 4.3943 +300 1 6.67133 7.90635 4.38865 4.30856 -16.1011 -10.8357 +301 1 8.27296 0.0768914 5.12036 9.18301 -5.97843 0.553246 +302 1 0.892643 0.477473 4.83579 -15.0913 15.4009 20.7636 +303 1 0.772154 0.130661 5.99646 -1.43861 1.07866 -2.10387 +304 1 8.25515 0.935072 5.88754 -0.221723 -11.6722 -2.23691 +305 1 1.48963 8.06671 4.97048 16.9477 -1.8997 -3.71962 +306 1 2.57496 1.15847 5.28752 41.8653 -9.27812 4.61709 +307 1 2.98732 0.492219 6.35067 -4.54422 -4.60939 3.20868 +308 1 1.84275 0.524647 5.86961 -0.917224 0.841047 0.660751 +309 1 2.97903 0.200446 5.09803 7.97745 -0.922342 6.62523 +310 1 4.26317 0.578438 5.09777 -3.02519 11.3137 -4.68966 +311 1 4.18994 0.120263 6.02339 -4.93913 2.59189 23.6551 +312 1 3.50295 1.24619 5.79637 -4.00764 -7.55023 -4.67003 +313 1 5.12205 8.32679 5.40632 -5.25746 3.73248 -3.11501 +314 1 5.80677 0.859185 4.97868 15.281 -0.410171 8.11126 +315 1 6.05354 -0.0201647 5.97574 -7.51195 2.16668 5.49645 +316 1 5.29101 1.10125 5.89955 -0.302158 5.37706 -3.33259 +317 1 6.70998 0.244047 5.12411 -32.2188 -6.24411 4.81733 +318 1 7.52467 0.777062 4.96861 20.8677 24.3354 -3.82818 +319 1 7.29721 0.136872 5.99355 7.05953 -3.3845 7.97045 +320 1 6.54852 0.902142 6.09075 8.2259 10.3777 -12.9847 +321 1 8.3753 1.53724 4.98157 2.17311 8.15625 3.98817 +322 1 0.71432 2.51412 5.02068 -12.4966 -5.84806 3.10051 +323 1 0.855781 1.46858 5.93628 -12.4576 1.96544 0.341226 +324 1 8.11454 2.43493 5.75559 5.15623 -3.74122 1.07022 +325 1 1.70238 1.57115 5.35189 -38.5773 5.62525 -16.043 +326 1 2.46473 3.0428 4.8535 14.9609 2.21644 20.6584 +327 1 2.4829 2.11442 5.80082 20.2757 20.5564 -2.76238 +328 1 1.44662 2.4329 5.9576 0.543772 11.9562 -7.2005 +329 1 3.29597 2.05528 5.06702 2.85074 -1.27902 5.48838 +330 1 4.71392 2.67227 4.67311 -16.586 -2.70867 4.26173 +331 1 4.23981 1.93327 5.61065 17.5416 10.5589 -1.008 +332 1 3.69151 2.91031 5.72032 0.213325 2.13196 -1.69169 +333 1 5.26041 1.83667 5.02123 6.06702 -8.01086 0.159199 +334 1 6.29681 2.56022 5.09106 -5.44623 -0.683824 -15.8447 +335 1 5.97089 1.97948 5.90875 -1.39581 -8.65091 2.36208 +336 1 5.32016 2.78712 5.54952 10.0834 -7.57686 9.12967 +337 1 6.76335 1.53665 5.10381 -6.49311 3.28388 -1.62508 +338 1 7.39244 2.59867 4.94069 -6.65618 -18.4022 10.6664 +339 1 7.39034 1.59037 5.98163 7.99848 2.50507 -1.85372 +340 1 6.86792 2.60296 5.96513 8.836 -3.98323 2.68287 +341 1 0.137435 3.52069 4.93684 -4.66205 -5.7882 5.56144 +342 1 0.88525 4.34994 4.6075 2.988 -8.04302 19.8618 +343 1 0.671447 3.60221 5.79043 18.0943 -16.6493 20.2037 +344 1 8.34285 4.28087 5.95434 -19.6744 13.1619 0.969809 +345 1 1.33416 3.36295 4.99473 8.92189 5.92429 -2.5153 +346 1 2.50305 4.23267 5.05465 -27.5248 -20.908 0.492103 +347 1 2.36725 3.37012 5.84923 -17.1073 -9.96579 7.0021 +348 1 1.45211 4.29673 5.57493 7.54138 6.26423 2.50823 +349 1 3.47656 3.71778 4.99943 12.588 -10.9937 -32.8348 +350 1 4.53758 4.28685 4.7978 -5.49767 21.5926 5.59595 +351 1 4.66123 3.56451 5.54467 -12.8933 9.0868 3.25853 +352 1 3.16215 4.0016 5.8872 6.62501 12.8548 34.5501 +353 1 5.39268 3.59146 4.74919 -4.73905 -31.3011 -11.4087 +354 1 5.76113 4.47956 4.9574 18.7428 32.3973 -5.18443 +355 1 5.78815 3.80587 5.78982 -7.10304 0.117864 -2.90029 +356 1 5.02789 4.67913 5.68892 -14.5359 -3.59396 7.83253 +357 1 6.67716 3.56196 5.1655 1.61752 2.79183 -0.67852 +358 1 7.59448 4.24592 4.9803 -6.50366 -1.98045 6.72657 +359 1 7.59718 3.39514 5.76655 2.21878 7.1556 0.646608 +360 1 6.80163 4.43627 5.8851 -3.03056 -0.645399 -10.9559 +361 1 8.29576 5.01058 4.81068 0.626199 13.0736 14.2059 +362 1 1.05047 6.19551 5.02762 -0.156468 -7.32209 -14.0064 +363 1 0.578297 5.15849 5.72641 1.63655 2.26956 0.551951 +364 1 8.23943 6.07268 5.87533 8.87399 -0.526239 1.15285 +365 1 1.76527 5.31835 4.93011 -1.00084 -16.0238 11.4126 +366 1 2.88183 5.91468 5.07925 -22.1885 -17.105 2.25231 +367 1 2.65936 4.93415 6.03537 0.686882 11.6758 -2.90902 +368 1 2.03447 5.84592 5.92534 2.47635 -18.2138 -25.6325 +369 1 3.24392 4.86959 5.11086 62.6624 1.69747 54.073 +370 1 4.07402 5.91621 4.83335 -4.98562 8.578 9.29517 +371 1 3.92826 4.74513 6.11781 2.52773 6.36319 -4.5061 +372 1 3.44964 5.83627 5.89312 16.6713 -3.51566 20.823 +373 1 5.12814 5.53194 4.84592 -22.4422 -5.59515 37.2611 +374 1 5.90308 6.17208 5.1146 -12.9736 21.9443 6.65273 +375 1 5.95357 5.13374 5.81819 6.93561 8.02219 4.14964 +376 1 4.75268 5.76162 5.94655 1.5775 -0.40438 -5.87077 +377 1 6.51586 5.41565 4.90612 17.2134 -26.1979 -1.37429 +378 1 7.5279 5.93793 5.01527 -3.38884 15.9345 -12.1825 +379 1 7.6332 5.21687 5.72128 4.22628 -40.3472 -14.2075 +380 1 6.64022 6.14894 5.87989 13.3598 -6.13205 -0.934618 +381 1 8.34458 6.85129 5.15926 -14.2808 -7.95422 -4.25663 +382 1 0.833911 7.25078 4.85532 9.11386 4.17832 -8.89911 +383 1 1.06673 6.48225 6.01607 -14.203 -6.44505 8.15493 +384 1 -0.0379195 7.65497 5.88016 -1.75378 4.76646 1.63712 +385 1 2.12599 6.69323 4.98422 2.81787 34.3524 37.6883 +386 1 2.84758 7.50703 5.20442 -10.9987 17.1664 -16.5728 +387 1 2.77128 6.71691 5.85642 -9.44911 -10.1768 15.1935 +388 1 1.58013 7.32255 5.72901 16.1676 5.29147 -4.24753 +389 1 3.6768 6.91779 5.33962 13.4611 -20.8664 1.96557 +390 1 4.03881 7.88236 5.22897 2.57592 -0.812644 -11.9679 +391 1 4.4232 6.75921 6.19682 -8.5477 -5.71312 7.44018 +392 1 3.24799 7.72667 6.18249 0.719386 0.220585 -2.48264 +393 1 4.83295 6.89566 5.2507 4.97045 -2.42982 -4.77289 +394 1 5.87897 7.61282 5.14968 -20.2612 -0.49131 -22.7769 +395 1 5.75942 6.67532 6.09541 -7.34504 3.57141 -0.447292 +396 1 5.14318 7.54839 6.30602 2.0724 10.313 -0.219969 +397 1 6.74639 6.92855 5.00696 6.96871 -0.230218 1.29861 +398 1 7.3805 7.8124 5.23875 7.69485 -10.0795 -7.08489 +399 1 7.52596 6.88746 5.90198 -6.42674 1.56965 2.19774 +400 1 6.51888 7.44621 5.87193 29.4637 -7.18826 32.3539 +401 1 8.28476 0.000423359 6.72306 2.02553 19.5279 -19.3713 +402 1 1.01888 0.905848 6.82221 -28.6303 -12.8009 -18.3361 +403 1 1.24262 8.30657 7.44334 -32.4348 0.998186 -42.9826 +404 1 0.0211475 0.824091 7.47144 0.973424 -13.5355 3.24171 +405 1 1.94007 8.12144 6.72811 7.36532 0.254467 -18.2635 +406 1 3.02097 1.5587 6.75498 -16.6323 -17.6578 -2.8331 +407 1 2.39982 0.0370076 7.66598 -2.14889 1.34284 -3.48663 +408 1 1.9688 0.847456 7.09398 30.835 -18.1107 26.5169 +409 1 3.29942 8.17609 7.18194 3.78499 -8.25924 -8.09048 +410 1 3.92844 1.06207 6.75726 8.02723 -15.5891 -9.47025 +411 1 4.52946 0.167766 7.50023 3.36063 -0.839689 -4.02118 +412 1 3.29302 0.728616 7.56048 2.70434 15.6737 2.80228 +413 1 5.10415 0.332413 6.57695 -15.8309 -23.3459 -1.79261 +414 1 5.90656 0.845621 6.88018 -8.12621 13.928 11.6173 +415 1 5.71058 8.18101 7.57391 -10.3063 5.31817 -1.8554 +416 1 4.82988 1.18118 7.265 13.8593 7.32067 6.7543 +417 1 6.57919 8.43785 7.00021 11.8406 5.1504 -4.86933 +418 1 7.5282 0.806752 6.77786 -1.5451 6.42857 5.82496 +419 1 7.48349 8.33572 7.57521 5.34797 11.8467 16.9658 +420 1 6.70557 1.08836 7.47923 9.5713 -7.54062 13.1357 +421 1 0.0382442 1.56126 6.72749 -0.0966071 11.4911 -0.854867 +422 1 0.869187 2.34639 6.83989 -3.61656 -2.89703 1.60294 +423 1 0.999275 1.45672 7.67633 -8.0034 9.48038 5.5647 +424 1 0.139215 2.63275 7.64328 -15.7892 -20.5267 5.19008 +425 1 1.88893 1.53066 6.37684 -7.83006 6.68056 5.79142 +426 1 2.1935 2.73769 6.82665 18.0903 -33.7124 -24.8324 +427 1 2.37018 1.89864 7.50076 -8.8745 -17.5059 -13.2094 +428 1 1.48561 2.41457 7.71452 -8.23366 6.90197 4.22635 +429 1 3.39063 2.48859 6.68098 16.1595 11.6225 -22.1191 +430 1 4.55604 3.04369 6.47522 -16.239 -17.1818 -0.0461326 +431 1 3.92972 1.83682 7.47298 10.0225 0.0134714 -13.9461 +432 1 3.03012 2.73851 7.57823 -7.17652 4.30522 18.5475 +433 1 5.02119 2.07008 6.4546 -13.5258 -22.6225 -4.75661 +434 1 5.65211 2.81921 6.68199 10.7014 16.4385 -2.46135 +435 1 5.81386 1.77715 7.51287 -3.39579 0.139075 -0.667502 +436 1 4.71678 2.54344 7.41951 15.4924 -28.3106 -11.236 +437 1 6.66707 1.83619 6.71865 -2.24275 1.62817 8.66814 +438 1 7.65934 2.42567 6.78337 1.29364 23.1589 -24.9484 +439 1 7.60492 1.76056 7.50233 6.44148 -25.2098 19.19 +440 1 6.42541 2.6971 7.41321 1.20391 11.9169 -7.49803 +441 1 0.132604 3.18129 6.70867 -2.29445 4.14817 -3.79866 +442 1 0.662351 4.17412 6.80772 -12.4952 0.818831 -9.43638 +443 1 0.788837 3.4069 7.65946 13.9586 12.3209 -0.784492 +444 1 8.14087 4.12742 7.481 16.3072 -9.43806 5.16356 +445 1 1.48457 3.42655 6.6105 -23.5819 5.37731 -5.67472 +446 1 2.19532 4.19793 6.62241 18.5812 -12.748 4.0704 +447 1 2.03418 3.35836 7.57671 1.74798 18.3537 22.2752 +448 1 1.46881 4.26381 7.4306 10.5669 6.85755 16.1187 +449 1 3.40116 3.57046 6.96596 -19.5489 -14.8384 -6.51121 +450 1 4.14086 4.23036 7.04697 14.6332 24.1596 -34.0677 +451 1 4.37587 3.46381 7.58097 -0.667569 -11.1793 25.3659 +452 1 3.3081 4.23862 7.84495 3.59222 -23.7983 19.5534 +453 1 5.02719 3.92296 6.55308 10.3874 19.2736 1.42121 +454 1 5.99108 4.37569 6.77029 -42.1869 -21.9594 -11.1356 +455 1 5.60639 3.61515 7.4373 -8.14506 -14.6497 -3.14446 +456 1 5.05417 4.46396 7.7264 -7.96475 -5.84314 -22.6526 +457 1 6.56389 3.51182 6.41915 7.41692 -2.85266 9.06964 +458 1 7.47152 4.32616 6.69237 -6.16955 -7.38805 -5.63513 +459 1 7.53898 3.20716 7.62579 -2.06037 -6.09637 -1.14724 +460 1 6.59589 3.90993 7.45755 23.4751 -0.996001 13.7582 +461 1 8.21483 5.0816 6.83956 12.3265 -1.95746 -0.89439 +462 1 0.465403 5.98278 6.74845 -2.0373 -17.3355 -17.4636 +463 1 0.511394 5.19401 7.82937 -10.2185 -4.74355 -3.50015 +464 1 8.12271 6.05839 7.46163 -7.84524 3.1436 -8.24587 +465 1 1.48514 4.9291 6.5693 -9.22109 4.87392 -22.494 +466 1 2.40623 5.73649 6.97099 14.0591 -30.3418 -0.240996 +467 1 2.41461 4.96776 7.80425 -3.8539 -8.74065 -18.3704 +468 1 1.44923 5.49011 7.41 13.6015 -14.5185 13.7078 +469 1 3.24542 4.75566 7.0008 -15.7357 21.5396 -25.2781 +470 1 4.03587 5.88736 6.84618 18.4928 -13.3364 -12.8531 +471 1 4.10808 5.01612 7.64484 -5.1777 21.728 20.8534 +472 1 3.29694 5.8019 7.54893 0.566822 -11.9233 11.3035 +473 1 4.81889 5.07278 6.77721 5.06549 -4.43332 1.49875 +474 1 5.96641 5.77692 6.72214 -33.9279 46.677 -28.2473 +475 1 5.88193 5.34623 7.60234 -1.49551 -23.3855 17.2998 +476 1 4.83941 5.81133 7.62234 25.0546 -26.9624 -0.550707 +477 1 6.63577 5.08354 6.75153 63.1873 3.33413 5.12133 +478 1 7.44477 5.7383 6.53202 -8.94815 26.2377 30.0386 +479 1 7.45353 4.90407 7.60234 6.61529 10.6464 -15.3985 +480 1 7.05207 6.05238 7.85033 -15.5225 4.97074 -5.49642 +481 1 8.33549 6.95757 6.75022 0.367032 -2.97861 0.255273 +482 1 0.891414 7.50932 6.49478 -4.83629 2.79466 11.3618 +483 1 1.06555 6.40917 7.42656 -9.40876 15.4887 12.6203 +484 1 0.19507 7.80618 7.47535 7.27195 -18.2248 4.26121 +485 1 1.90915 6.5235 6.63557 -10.6214 46.709 18.7487 +486 1 2.60482 7.35009 7.06318 -2.87326 8.86923 -10.12 +487 1 2.54785 6.52686 7.66612 -14.5904 -1.60347 8.59865 +488 1 1.54201 7.28494 7.4147 7.26892 14.9372 -8.95427 +489 1 3.42163 6.7113 6.72693 -9.74068 0.0780566 2.81617 +490 1 4.07503 7.52705 6.85904 11.3718 5.59625 6.13428 +491 1 4.17032 6.5317 7.69612 -24.7224 6.99609 -12.8841 +492 1 3.30541 7.28919 7.8835 -6.45113 3.62128 -9.60987 +493 1 5.18135 6.6767 7.03146 3.30189 -12.2169 -7.11599 +494 1 6.1441 7.48882 6.87735 -8.40006 -9.95553 -2.76953 +495 1 5.99111 6.52776 7.79328 26.4283 6.66779 -19.7705 +496 1 4.88188 7.45813 7.61707 18.1033 18.9899 -14.9739 +497 1 6.70265 6.55612 6.94114 4.37785 1.73726 -4.76735 +498 1 7.52255 7.69097 6.78657 -11.7433 -15.8982 -13.9562 +499 1 7.60662 7.23551 7.85952 12.3776 -11.2962 -9.39843 +500 1 6.63368 7.62048 7.85195 7.88485 3.15928 -11.7162 +ITEM: TIMESTEP +300 +ITEM: NUMBER OF ATOMS +500 +ITEM: BOX BOUNDS pp pp pp +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +0.0000000000000000e+00 8.3979809569125372e+00 +ITEM: ATOMS id type x y z f_2[1] f_2[2] f_2[3] +1 1 0.233349 8.13006 8.37458 -13.2268 13.2109 8.94155 +2 1 0.896766 0.85308 8.30255 3.22629 3.6978 6.45643 +3 1 0.859864 0.0707018 0.945242 -23.4126 -16.0712 -18.9613 +4 1 0.0588758 0.842768 1.07285 9.62638 -2.91549 -12.4893 +5 1 1.77938 8.21846 0.149185 -27.8434 -16.3109 -1.32989 +6 1 2.24018 0.700289 8.36085 16.269 9.92358 -3.41709 +7 1 2.6315 8.21417 0.711168 13.3859 0.245092 -3.82819 +8 1 1.39092 0.935915 0.985394 12.7346 13.01 -5.10945 +9 1 3.3176 8.39636 8.17869 -11.566 -16.9274 13.6338 +10 1 3.85219 0.815062 0.0370236 10.4004 28.9589 -3.67884 +11 1 4.161 0.0319779 0.627546 1.75904 -7.59281 -2.75644 +12 1 3.11636 0.817642 0.847547 4.80203 -27.6102 -6.44654 +13 1 5.13793 8.3571 8.28888 -5.17208 4.97346 2.0085 +14 1 5.70385 0.905818 8.12031 -17.8373 19.4407 -6.83741 +15 1 5.79877 0.0963845 0.817928 -4.38032 -1.5507 0.666839 +16 1 4.98412 1.21117 0.664665 -21.555 -8.66432 0.346644 +17 1 6.45061 0.296088 8.38812 3.42924 -28.9348 -2.0588 +18 1 7.77702 0.350545 0.295684 -0.731277 11.544 -2.82186 +19 1 7.70462 8.17101 1.16161 -8.03851 17.5755 -13.9844 +20 1 6.86494 0.586624 0.875444 5.58847 2.16197 13.2587 +21 1 0.100678 1.61145 0.0186749 -1.1873 -11.6656 4.66894 +22 1 0.998429 2.3998 8.22988 -7.28085 -4.5005 5.89326 +23 1 0.828996 1.87962 0.867267 -19.2592 -9.93125 -3.90703 +24 1 8.27374 2.4894 0.580898 8.78255 -11.7455 7.53659 +25 1 1.74048 1.62493 8.26739 -9.18296 -12.9889 2.92816 +26 1 2.39558 2.37629 0.0600193 9.87685 24.4855 1.90731 +27 1 2.45445 1.58898 0.877492 -32.2642 -6.64837 2.63885 +28 1 1.65243 2.45558 0.846906 19.966 -6.37675 -0.113589 +29 1 3.02408 1.54485 8.35689 5.59986 -7.64836 -2.85923 +30 1 3.92 2.20197 8.38732 -20.8443 12.2841 2.52306 +31 1 3.77985 1.57027 0.846646 20.9907 13.6119 -1.22324 +32 1 3.10388 2.34584 0.944358 6.32701 23.9593 -3.77688 +33 1 4.85706 1.878 8.25981 8.11354 -3.87323 -9.47245 +34 1 5.78268 2.09333 0.29673 -1.36849 16.4599 4.03726 +35 1 5.97863 1.20376 0.790291 32.0463 2.36619 -11.4383 +36 1 4.88385 2.45634 0.850397 9.78281 -16.7958 -1.62774 +37 1 6.62285 1.61835 8.29579 8.05661 -4.4773 5.02204 +38 1 7.55399 2.56197 8.18132 12.8994 -8.38166 15.4695 +39 1 7.59924 1.47112 0.768275 -0.340381 -2.67871 -5.54587 +40 1 6.74877 2.64386 0.753723 -17.0902 -18.9793 -10.4389 +41 1 8.35722 3.30339 8.29621 3.88209 -7.05803 1.13469 +42 1 0.765977 3.99405 0.477073 10.4517 2.49603 -17.2656 +43 1 0.831221 3.06707 0.900453 -8.35587 -6.78904 7.02328 +44 1 0.140436 4.39767 1.19127 -1.57081 11.5239 1.23833 +45 1 1.55351 3.27393 8.36662 -0.118073 6.26889 7.92677 +46 1 2.48303 4.16731 0.14908 -13.7582 -4.26857 1.92322 +47 1 2.37333 3.17517 1.02067 -14.4692 6.50264 -31.5071 +48 1 1.65701 4.17058 1.15287 -1.5797 -1.97941 -12.8817 +49 1 3.21438 3.21157 0.146996 -20.1594 -11.7694 11.9952 +50 1 4.28321 4.06082 0.235561 -7.01013 0.464645 -7.4456 +51 1 4.00184 2.96868 0.822048 -4.54826 25.7516 -18.5713 +52 1 3.26412 4.08833 0.821613 11.1851 4.36305 6.27367 +53 1 4.93889 3.19103 0.0459746 -2.17639 -1.1271 -7.48927 +54 1 5.93535 4.0528 8.21654 -1.56333 -1.65165 1.96928 +55 1 5.75576 3.15988 0.707778 17.6817 -13.2713 5.13403 +56 1 5.2315 4.02943 0.763223 -0.452475 -6.04463 7.12931 +57 1 6.80967 3.18308 7.98158 -23.2698 3.29018 18.9116 +58 1 7.84937 4.15894 0.139115 -10.2897 11.6744 2.993 +59 1 7.56351 3.24008 0.752033 -0.468845 18.0521 -12.3044 +60 1 6.70326 3.88955 0.624889 -0.941138 0.59008 2.25635 +61 1 0.263315 4.89557 0.260533 -21.3177 5.01328 -15.5704 +62 1 0.767954 5.80979 8.30607 7.59978 -5.84563 1.67074 +63 1 1.01162 5.03409 0.908989 7.54529 2.69929 16.3999 +64 1 8.38725 5.83431 1.00337 3.61589 -4.15339 -6.36164 +65 1 1.65923 4.84747 0.0732901 -12.2718 -7.14452 -1.11973 +66 1 2.34253 5.60198 8.30655 7.91513 22.3685 24.006 +67 1 2.47075 4.92775 0.922768 -5.69599 3.89765 2.66746 +68 1 1.65076 5.8624 1.08155 8.28384 13.1663 -26.7168 +69 1 3.21032 4.96288 0.0718385 6.90275 12.0583 4.83562 +70 1 4.31683 5.81091 8.2445 -6.07106 16.001 24.4162 +71 1 4.0022 5.10933 1.08243 -0.987394 -5.51353 -4.14418 +72 1 3.08952 5.8543 1.08001 20.7019 -13.8856 -23.646 +73 1 5.04193 4.8848 0.236201 -6.75887 8.84809 -11.6728 +74 1 6.01036 5.86922 0.147762 0.616812 -0.708561 -9.8882 +75 1 6.00591 4.76669 0.704892 -5.00399 3.30231 -11.9912 +76 1 5.15986 5.7957 0.727818 -36.1273 9.99449 -4.0864 +77 1 6.87642 4.89744 0.140008 2.16293 1.86546 -13.7103 +78 1 7.84039 5.5603 8.24691 -4.77039 2.45387 6.97935 +79 1 7.61247 4.95216 0.884224 61.5464 5.54866 -31.4574 +80 1 7.13999 5.87097 0.66837 -10.4004 0.446979 -1.0889 +81 1 0.284976 6.68434 0.215945 -19.2498 8.05662 -14.0567 +82 1 0.982876 7.472 8.30358 11.1034 -5.67626 13.795 +83 1 0.874256 6.63686 1.03265 -11.7399 -6.70777 -2.09767 +84 1 0.12523 7.53526 1.06205 -15.5002 -8.52158 -32.9301 +85 1 1.53836 6.56542 0.124336 5.81155 -2.74575 2.70263 +86 1 2.45566 7.24014 0.163939 -13.7862 7.0524 3.90305 +87 1 2.38368 6.64181 1.16489 5.19309 13.0368 -14.4547 +88 1 1.55777 7.42064 0.955187 2.95317 9.919 -9.12596 +89 1 3.26105 6.57879 0.277391 6.19764 -3.88127 -4.29904 +90 1 4.21681 7.50418 8.36589 0.418779 7.33048 -0.673966 +91 1 4.2136 6.71573 0.805769 6.02261 -2.81289 0.798739 +92 1 3.49573 7.57967 0.77094 -13.8185 -15.1907 -22.6007 +93 1 4.97943 6.65519 6.77102e-05 6.49698 2.41559 -0.5205 +94 1 5.78763 7.50739 0.0292034 7.17211 6.93093 1.18788 +95 1 5.70061 6.80412 0.815144 6.83872 -8.02569 -5.22668 +96 1 4.96155 7.64188 0.754906 -1.40971 0.48378 3.60676 +97 1 6.62543 6.75834 0.212141 20.3815 -6.72799 19.0936 +98 1 7.5054 7.54064 0.228699 5.02405 -0.59125 8.31674 +99 1 7.62741 6.7648 0.966544 10.8528 -1.51524 -6.86782 +100 1 6.51764 7.61106 0.794066 -3.58188 15.2202 -2.22905 +101 1 0.0861403 8.39942 1.77523 16.561 5.47177 12.0456 +102 1 0.798241 0.867486 1.90283 5.83429 -6.22483 -1.18959 +103 1 1.01882 8.16093 2.58804 1.69129 37.21 2.68102 +104 1 8.26047 0.933232 2.39213 16.6191 -6.94084 19.3019 +105 1 1.5043 8.31602 1.70005 24.5225 8.22354 6.48742 +106 1 2.3278 0.505699 1.44491 -1.87805 7.24432 12.5632 +107 1 2.30107 0.0675885 2.61736 -2.34035 -25.4089 0.204635 +108 1 1.65389 0.877547 2.65941 -7.28266 6.33447 -16.1438 +109 1 3.50019 8.31721 1.47862 -16.7888 14.1081 10.898 +110 1 4.01956 0.825924 1.54962 -26.8746 12.2857 6.16059 +111 1 4.07538 0.019132 2.44171 -4.87493 0.404402 -2.17065 +112 1 2.869 0.885962 2.4149 5.17917 -2.47967 0.533766 +113 1 4.73464 0.155071 1.4932 30.6868 -26.2406 6.98684 +114 1 5.62968 0.817396 1.64834 -4.04481 -8.77462 16.8173 +115 1 5.66865 0.0141325 2.50366 17.0023 -1.89327 -13.9307 +116 1 4.86842 0.817468 2.42132 32.27 -13.4362 -6.77265 +117 1 6.59541 8.31415 1.73549 -0.21361 15.3936 4.52423 +118 1 7.59767 0.742823 1.6565 -21.3952 4.75735 -8.6823 +119 1 7.60945 8.3635 2.38741 -3.47518 -4.35582 8.08118 +120 1 6.64964 0.766964 2.59458 1.86331 7.94862 -15.7507 +121 1 0.0966564 1.72383 1.66126 -2.3646 2.96568 -2.77323 +122 1 0.838875 2.52792 1.96878 -8.15441 10.7797 -1.95863 +123 1 0.90776 1.65168 2.68747 -10.1162 -2.78056 -2.47535 +124 1 8.34426 2.2614 2.55151 21.19 -10.0612 15.2043 +125 1 1.46427 1.72978 1.76157 8.28796 -9.22695 -3.48387 +126 1 2.37501 2.29161 1.76614 -0.0664736 7.90276 1.49641 +127 1 2.67166 1.85508 2.81423 -4.33867 8.71682 -6.36279 +128 1 1.69129 2.40006 2.69001 -6.84808 74.503 -77.1336 +129 1 3.2606 1.69371 1.92128 -6.02725 -3.6159 -16.3817 +130 1 3.94104 2.38885 1.63591 5.99851 11.0997 18.049 +131 1 4.04449 1.32304 2.52718 -28.9333 17.8748 13.0885 +132 1 3.64404 2.34301 2.71879 -4.29604 2.09188 -4.97764 +133 1 4.64091 1.6418 1.58405 19.1918 -0.189122 5.88078 +134 1 5.88395 2.31133 1.52544 0.0797298 5.40617 -9.4435 +135 1 5.7987 1.64961 2.35436 -3.46325 -3.79932 12.9903 +136 1 4.78244 2.22308 2.51874 2.01011 -1.75623 -4.81914 +137 1 6.65439 1.55727 1.69251 0.0481382 -10.7878 -2.86985 +138 1 7.4609 2.22018 1.51079 9.36137 15.4008 -1.67913 +139 1 7.50576 1.63853 2.4128 -2.97032 -17.2864 -0.621812 +140 1 6.87214 2.43415 2.42038 -30.5876 3.19651 2.74052 +141 1 8.27498 3.12542 1.46263 16.9155 1.32854 13.6822 +142 1 0.778659 3.95642 1.86807 -7.25106 -12.2522 -5.40095 +143 1 0.798965 3.10856 2.99966 -8.51883 26.4353 -21.6316 +144 1 8.39629 3.85082 2.58225 -5.99614 1.48776 4.40527 +145 1 1.68381 3.21805 1.79101 -5.77633 -5.0861 7.47296 +146 1 2.56903 4.03114 1.71918 -6.92524 18.9919 2.42009 +147 1 2.68821 3.054 2.58052 -0.955464 -0.812242 -0.180548 +148 1 1.68992 4.20726 2.20027 5.368 3.11181 32.2719 +149 1 3.19042 3.29104 1.54336 50.4233 -29.9172 14.5641 +150 1 4.30208 4.0236 1.30142 -3.92395 -1.77865 11.4065 +151 1 4.28898 3.18994 2.59219 8.96711 6.3942 -10.7611 +152 1 3.60727 4.0096 2.21837 0.742083 4.13896 4.48687 +153 1 5.11886 3.09922 1.66619 -2.87182 6.36609 5.71268 +154 1 5.98984 4.3721 1.6574 7.23512 -22.1503 15.9695 +155 1 6.06757 3.38048 2.48886 -0.631751 -1.09061 1.54872 +156 1 5.04095 4.05582 2.29794 7.98224 -6.57422 -3.38111 +157 1 6.80585 3.23363 1.61955 1.81547 4.43083 5.90353 +158 1 7.6107 4.12271 1.4985 -13.6918 -18.0547 7.51636 +159 1 7.71076 3.00605 2.3508 1.14441 21.4666 -12.0177 +160 1 6.92831 4.10176 2.31565 -3.92153 2.58619 4.8482 +161 1 8.33973 5.1724 2.08404 -22.306 -14.8391 -35.8531 +162 1 0.860537 5.83051 1.79504 -25.5953 10.3696 1.23396 +163 1 0.802813 4.96181 2.52052 20.0549 -14.1798 16.2425 +164 1 8.20479 5.88748 2.7573 8.86056 43.8975 -14.7096 +165 1 1.62556 5.15881 1.79421 13.6671 -60.0224 -43.8322 +166 1 2.44832 5.82052 1.83706 -21.0979 -8.85922 15.9808 +167 1 2.35829 4.95884 2.60055 5.56499 -3.25718 -17.7316 +168 1 1.57047 5.68188 2.57793 3.26945 48.3874 60.3367 +169 1 3.12962 4.94115 1.79611 3.44797 3.66295 -7.67081 +170 1 4.533 5.88518 1.61818 -3.82507 3.84853 0.541056 +171 1 4.41047 4.91386 2.27111 -7.04817 9.97354 -0.554451 +172 1 3.1705 5.97206 2.56867 13.8835 0.36015 7.54685 +173 1 5.10201 4.84379 1.45925 -8.99072 13.7146 -7.42642 +174 1 6.04077 5.71462 1.17105 24.8221 7.94918 20.2395 +175 1 6.02655 5.34395 2.16117 8.67798 2.32994 -0.236737 +176 1 5.13754 6.13757 2.45889 -19.0768 2.88926 -22.199 +177 1 6.81157 4.98564 1.3948 -36.2833 4.79272 33.0954 +178 1 7.60086 5.99469 1.7372 -3.24829 -8.45789 -2.93345 +179 1 7.33283 5.34101 2.57932 2.07328 -12.097 -6.46632 +180 1 6.77196 6.24125 2.34214 -17.3674 -5.70799 13.1243 +181 1 0.0250537 6.6606 1.72753 8.49396 4.93702 8.33356 +182 1 0.795762 7.59079 1.77266 12.7999 -27.3678 15.1487 +183 1 0.926657 6.70523 2.69571 -0.793657 3.91691 -3.18748 +184 1 0.160908 7.59778 2.74546 -5.44053 4.97464 -19.9661 +185 1 1.54893 6.69469 1.77147 8.37496 4.15768 30.0144 +186 1 2.38553 7.66265 1.59156 1.85092 -2.31642 6.75994 +187 1 2.52893 6.74213 2.34554 9.20138 12.1517 -25.6716 +188 1 1.80175 7.4451 2.61158 -6.78811 17.5009 -13.1399 +189 1 3.38458 6.74038 1.57533 -10.1646 -3.59545 3.61897 +190 1 4.095 7.47851 1.58866 27.0187 15.4009 2.51878 +191 1 4.11379 6.83 2.37783 19.5598 -18.1657 -14.1463 +192 1 3.12959 7.71074 2.36405 10.6634 -2.49932 -15.2866 +193 1 5.08729 6.94297 1.62592 -21.1801 -24.4484 5.07107 +194 1 5.73581 7.71377 1.57745 5.16642 11.3097 -0.890489 +195 1 5.92001 7.08484 2.45291 -0.193261 -0.933403 -1.70059 +196 1 4.83819 7.59024 2.39768 8.18574 14.9342 11.0206 +197 1 6.61545 6.66525 1.38958 -18.6406 -25.8802 -11.2439 +198 1 7.15994 7.45994 1.57935 11.6501 4.19084 33.778 +199 1 7.56748 6.9114 2.40976 10.0926 4.81165 9.43494 +200 1 6.80428 7.72449 2.78938 -1.24224 -1.60677 -10.8659 +201 1 0.159784 0.136544 3.24366 -1.32953 4.05967 1.66335 +202 1 1.00698 0.811307 3.51207 1.50245 1.78035 6.01503 +203 1 1.34713 0.12551 4.66914 -24.521 -31.0514 3.16868 +204 1 0.0655245 0.668593 4.25847 -0.855275 2.59789 -3.35749 +205 1 1.74942 8.37675 3.57933 -10.207 -16.1779 -1.21978 +206 1 2.26863 0.82911 3.48792 22.6881 17.8048 9.09595 +207 1 2.33553 0.183914 4.4711 16.8323 -1.13179 -15.08 +208 1 1.7049 1.03332 4.4695 6.78822 33.3459 -7.07653 +209 1 3.29237 0.411287 3.32326 -2.12858 -4.79866 -0.866625 +210 1 4.21141 0.796867 3.72276 15.2258 15.2508 -15.0202 +211 1 4.33441 8.33993 4.30342 13.6521 7.25398 3.1725 +212 1 3.45786 0.725922 4.42039 -13.4693 -6.1715 4.46767 +213 1 4.89231 0.0473082 3.15782 -6.25621 1.30634 20.3282 +214 1 5.77362 0.736119 3.37748 -9.09312 1.23928 -13.4649 +215 1 5.99071 8.04065 4.47949 -15.8189 13.2428 -8.46949 +216 1 5.196 0.682234 4.2587 4.7081 -6.90451 -0.266688 +217 1 6.57106 0.145322 3.40637 19.3462 -23.2913 17.9258 +218 1 7.59401 0.663732 3.46257 -2.8602 2.11131 -2.24016 +219 1 7.44242 8.25412 4.2449 1.11307 19.9225 9.74876 +220 1 6.62382 0.709572 4.35284 3.66026 3.16927 -3.64727 +221 1 0.0779483 1.38159 3.37319 -4.4953 5.38733 3.01304 +222 1 0.974278 2.30233 3.53228 -23.5961 -13.9704 29.7447 +223 1 0.524182 1.77379 4.53785 8.44119 -12.0369 -19.76 +224 1 8.32657 2.54461 4.19453 11.685 -8.01921 4.29442 +225 1 1.79699 1.78778 3.36592 20.9053 -94.2146 75.3552 +226 1 2.26904 2.65097 3.69138 3.64635 0.74501 -3.21688 +227 1 2.67429 1.70202 4.43144 -1.62218 -6.52331 -3.16444 +228 1 1.67869 2.25152 4.52595 21.8057 -26.9163 -24.6655 +229 1 3.42529 1.64095 3.50559 7.24234 -14.969 7.63922 +230 1 4.36843 2.51227 3.48596 2.07064 -5.87084 11.4812 +231 1 4.83369 1.71242 4.31187 -12.4342 -5.24453 -2.55025 +232 1 3.42697 2.55135 4.03879 13.1661 -11.4647 -6.22039 +233 1 5.09889 1.5127 3.30322 -10.1348 7.40169 -7.59726 +234 1 6.05204 2.45182 3.35855 -5.34479 4.21286 -4.99107 +235 1 5.91247 1.54121 4.03978 -1.19872 3.24833 9.47786 +236 1 5.34566 2.59829 4.30389 3.31953 7.26855 -16.7286 +237 1 6.74657 1.65018 3.27179 -23.12 -29.0051 -3.67746 +238 1 7.53263 2.23686 3.30386 26.344 22.8452 7.39879 +239 1 7.49613 1.58204 4.21155 10.9589 -18.8504 -4.35663 +240 1 6.70452 2.2326 4.19472 -13.7578 19.073 -7.70781 +241 1 8.04948 3.18864 3.48276 7.81989 17.0755 -15.6642 +242 1 0.420364 4.02026 3.62891 2.0762 -18.0048 -13.8871 +243 1 1.02911 3.20723 4.10028 2.87528 5.61338 3.46722 +244 1 8.23518 4.59996 4.24867 -9.72892 -14.3069 11.6196 +245 1 1.79813 3.62221 3.14835 -2.38332 -26.1643 0.00682256 +246 1 2.74246 4.09054 3.06778 10.2172 -0.241531 -5.01738 +247 1 2.65108 3.56469 4.0066 1.29528 2.95166 -0.450344 +248 1 1.68753 4.16642 4.41008 0.531244 0.36282 -0.905409 +249 1 3.56157 3.26659 3.34031 -15.156 16.0178 -13.2173 +250 1 4.30786 4.20161 3.07587 -3.71718 9.6458 -20.0534 +251 1 4.29173 3.71129 3.93288 2.63232 -25.6185 20.4798 +252 1 3.34785 4.41255 3.95574 4.30294 0.337698 1.30747 +253 1 5.19196 3.15058 3.27975 2.68017 7.34728 -0.723223 +254 1 6.11836 4.37563 3.09786 3.48097 -0.455645 -7.15348 +255 1 6.16379 3.4966 3.8024 -0.493793 0.0328113 2.1336 +256 1 5.30251 4.52711 3.80393 -16.2632 -25.1941 -0.0075048 +257 1 7.08947 3.30091 3.10932 -23.6486 5.19633 4.56168 +258 1 7.44697 4.43668 3.27896 -0.511887 -2.93371 -0.292771 +259 1 7.26132 3.68038 4.11877 19.5278 5.77559 -31.2062 +260 1 6.65227 4.59556 4.02535 -2.98634 0.729124 1.77093 +261 1 8.32438 5.07972 3.31456 7.45197 -18.3523 8.49382 +262 1 0.7239 5.87238 3.35063 13.9037 -7.68163 -11.6827 +263 1 0.86133 4.86733 4.0112 5.23908 17.06 9.33784 +264 1 0.110376 5.99228 4.15088 -19.5006 -5.14624 15.1727 +265 1 1.63326 4.60922 3.31023 -1.76723 17.8491 2.08855 +266 1 2.40135 5.61695 3.38494 19.4662 4.44663 -11.3673 +267 1 2.36184 5.08435 4.31966 -1.81965 -14.9274 -8.60789 +268 1 1.71701 5.94552 4.03684 -24.0402 -0.0953197 5.79012 +269 1 3.43912 4.9954 2.79577 7.89838 -10.7079 17.2388 +270 1 4.22838 5.86109 3.02821 33.6181 3.37383 -45.0173 +271 1 4.24887 5.06359 3.71273 2.64953 -0.546445 2.15952 +272 1 3.55742 5.92395 3.71083 -38.5919 -3.44905 39.4056 +273 1 5.41837 5.23828 2.98577 -11.447 -4.74628 10.7983 +274 1 5.86494 6.22754 3.11739 14.9731 7.40151 22.8162 +275 1 5.75467 5.37436 4.08221 13.6205 23.921 6.83069 +276 1 4.77382 6.13694 3.95439 -2.74813 -13.8938 10.4295 +277 1 6.55906 5.4789 3.24844 0.234698 -8.05013 11.4476 +278 1 7.53331 6.151 3.48116 -10.0459 9.16913 -20.7264 +279 1 7.59712 5.40949 4.12314 -10.2706 -23.4933 17.211 +280 1 6.76315 6.15422 4.20451 -8.32818 -2.13306 4.306 +281 1 8.33074 6.79274 3.30017 10.9969 -9.86444 14.3566 +282 1 1.03943 7.60681 3.41422 12.8839 -22.0033 7.43641 +283 1 0.876997 6.68124 4.1033 12.4942 12.9257 -7.86127 +284 1 0.320289 7.62896 4.11358 -19.9566 8.93301 7.64028 +285 1 2.12233 6.73507 3.25947 -6.36672 -13.9408 34.1069 +286 1 2.9278 7.71082 3.35699 -9.10575 13.9767 3.53664 +287 1 2.86555 6.96099 4.04549 -8.29151 -16.9355 4.68952 +288 1 1.89553 7.49272 4.25249 -6.95602 2.25366 -4.36835 +289 1 3.55128 6.82828 3.17739 -22.1877 4.18931 17.356 +290 1 4.1661 7.71123 3.4095 -5.10369 -4.69259 -0.796458 +291 1 3.89274 6.87937 4.19693 15.4298 1.82254 7.44647 +292 1 3.39266 7.95134 4.30177 -1.7872 -21.2114 -27.9517 +293 1 4.99714 6.86548 3.27273 -3.15325 15.5146 -9.80269 +294 1 5.7604 7.67976 3.37293 2.05238 1.22428 3.6757 +295 1 5.73479 6.76996 4.15088 6.33474 -4.66485 -1.392 +296 1 5.07616 7.57695 4.40446 -13.6351 -7.42167 0.514113 +297 1 6.73778 6.81794 3.33301 -3.54485 0.402493 -5.08336 +298 1 7.71498 7.67053 3.44695 -0.752689 -3.6099 -11.6949 +299 1 7.71759 6.87965 4.22182 -5.11403 5.07303 3.22293 +300 1 6.7649 7.45476 4.17956 6.56157 -12.3801 -0.724651 +301 1 8.19197 0.136233 5.17288 2.67067 20.6746 -19.9914 +302 1 0.776102 0.931351 5.08619 -1.70464 -8.91233 1.85235 +303 1 0.888781 0.0179834 5.65999 -4.55543 21.0031 13.534 +304 1 8.38466 0.737331 6.00004 -6.63761 5.81892 -3.68334 +305 1 2.17326 8.16764 5.48567 -30.0571 8.40977 9.50779 +306 1 2.68565 0.975823 5.34104 11.1467 5.8174 -19.2362 +307 1 3.06444 0.336871 6.1128 1.74673 -5.08128 15.5867 +308 1 1.94778 0.751629 6.0231 -12.5402 -6.77103 11.9096 +309 1 3.09215 -0.0018856 5.12048 23.3711 9.80891 31.3016 +310 1 4.54285 0.96074 5.03055 -10.8439 -8.47943 8.00065 +311 1 4.19772 8.25187 6.2874 -2.87662 7.25597 -11.3947 +312 1 3.73883 1.45482 5.73884 -5.31372 -3.16529 -7.8226 +313 1 5.15615 8.35466 5.42348 2.42368 -1.79965 -6.24325 +314 1 5.91471 0.891384 5.15303 -5.07011 -3.09253 -0.460458 +315 1 6.03745 8.35632 6.14961 -1.39208 3.8678 -5.18235 +316 1 5.2121 0.86593 5.98804 -13.8254 0.446509 -12.536 +317 1 6.68868 8.34181 5.14194 3.9888 6.48649 16.9974 +318 1 7.34021 0.809849 5.26372 -2.78853 -11.1974 -10.3326 +319 1 7.36245 8.30575 6.05369 1.98185 25.0408 -10.0092 +320 1 6.64158 0.85851 5.99168 -3.68623 1.19752 6.36998 +321 1 8.13309 1.40671 5.10096 17.8835 4.45702 -4.02515 +322 1 0.892662 2.59499 5.00421 -20.8235 21.437 24.4928 +323 1 0.773043 1.57142 5.91415 4.22614 9.86073 2.56515 +324 1 8.33239 2.57823 5.60038 -0.623629 0.0892147 1.2306 +325 1 1.87225 1.66498 5.43985 -2.48264 -4.0236 -4.58226 +326 1 2.75473 2.72259 4.73435 -30.311 11.1987 -1.55273 +327 1 2.93165 2.12687 5.49641 -1.73472 -35.7803 16.6222 +328 1 1.7335 2.58373 5.90704 -3.71318 12.7214 1.30751 +329 1 3.77896 1.69526 4.65032 1.63977 11.6216 2.36832 +330 1 4.33882 2.78478 4.62298 7.45227 7.00188 -24.1667 +331 1 4.0935 2.44339 5.52545 -11.3615 -7.17888 20.8862 +332 1 3.18285 3.03749 5.86709 11.7107 14.2608 -10.1303 +333 1 5.16253 1.77254 5.33362 4.38648 8.73211 2.03951 +334 1 5.9743 2.78241 5.0854 16.8461 0.569184 7.37091 +335 1 6.05449 1.8557 6.00418 -1.07841 -2.85482 0.754485 +336 1 5.02736 2.93607 5.49369 -0.394928 -5.32288 -0.0457358 +337 1 6.65738 1.68333 5.09298 2.04945 -3.50949 1.46808 +338 1 7.506 2.4535 4.81544 -2.36267 6.50792 21.426 +339 1 7.5049 1.81157 5.81254 2.0705 -7.66144 9.63716 +340 1 6.81799 2.57614 5.74327 -5.22025 12.4071 0.584392 +341 1 8.08209 3.4329 4.82809 -0.388102 0.733533 -0.302449 +342 1 0.687603 4.05264 4.91973 13.3113 7.10483 -26.1293 +343 1 0.927182 3.40713 5.70883 1.42 -2.21252 8.41121 +344 1 8.39125 4.08596 5.64374 -17.7983 3.69834 21.9629 +345 1 1.85335 3.18328 4.91159 -22.5662 10.1648 8.61749 +346 1 2.62594 3.83741 5.0269 -11.5374 29.2389 12.1219 +347 1 2.23001 3.64598 5.99431 12.2251 -19.0314 6.6066 +348 1 1.61612 4.36322 5.62412 -4.72812 -41.6645 3.65456 +349 1 3.49026 3.4159 4.80384 34.5623 1.92174 -9.26957 +350 1 4.42781 4.48169 4.58587 2.89283 12.0072 14.2383 +351 1 4.32987 3.73273 5.40213 -1.15236 0.923586 4.29704 +352 1 3.35747 3.99106 6.24745 4.6285 19.5949 -5.94829 +353 1 5.1733 3.66262 4.57851 -0.760359 -3.40804 -5.73178 +354 1 5.75745 4.60154 4.93992 12.48 38.3619 -39.183 +355 1 5.60952 3.84508 5.51193 1.72033 -36.6996 37.1733 +356 1 4.90838 4.64872 5.58962 -7.33472 10.9707 -1.22542 +357 1 6.81366 3.55073 4.97382 -24.7572 -16.3635 34.7513 +358 1 7.36231 4.42367 5.08055 17.1166 2.62568 -2.95463 +359 1 7.4725 3.41969 5.92572 4.71216 -0.444272 -3.67252 +360 1 6.56495 4.37474 5.82163 -0.033274 -9.82017 -6.2351 +361 1 0.041011 5.18659 5.08838 -22.5443 6.51501 -27.8507 +362 1 1.02655 6.1046 4.9959 -2.55187 -8.42255 -9.06362 +363 1 0.725543 4.91454 5.73466 12.2313 -2.94426 20.5318 +364 1 0.0422288 5.86356 5.87032 0.0942915 12.4442 -1.56822 +365 1 1.61098 5.19782 5.1268 2.44581 33.2387 -21.9348 +366 1 2.65636 5.69092 5.09384 11.8609 0.215073 14.2086 +367 1 2.6104 4.85981 5.98721 5.66035 -5.70161 -4.77737 +368 1 1.90538 6.1737 5.70769 -41.2624 -24.39 16.3086 +369 1 3.46858 4.77582 5.16944 -0.707582 -1.43422 0.766057 +370 1 3.76426 5.90532 4.89181 3.4437 -1.11423 -2.15979 +371 1 4.07073 4.92867 6.32743 11.4607 -11.4553 -4.32634 +372 1 3.67793 5.86643 6.05942 -4.35866 5.03724 -1.47182 +373 1 4.98792 5.51389 4.93524 -8.4187 -10.8933 -4.11136 +374 1 5.89023 6.01641 5.05179 11.0493 7.97987 -0.316877 +375 1 5.84913 5.21289 5.8287 7.09495 5.60009 -11.1489 +376 1 4.95887 5.92462 6.03819 -1.41241 -1.47294 -8.90972 +377 1 6.72618 5.24569 4.87739 -4.6501 10.2679 6.06598 +378 1 7.69701 6.07801 4.9728 1.45309 -5.4044 1.15049 +379 1 7.57443 5.25318 5.8022 -4.19719 -6.86637 2.5693 +380 1 6.75672 5.96198 5.84181 4.25859 -4.73277 0.116077 +381 1 0.149236 6.9327 4.88187 0.301354 -7.8021 16.5737 +382 1 1.06612 7.54377 5.19235 6.17987 -18.0682 -12.1896 +383 1 0.908663 6.67909 5.83913 1.89859 7.5565 8.00921 +384 1 8.3967 7.73373 5.73713 17.5958 -22.201 25.7152 +385 1 2.09262 6.53099 4.7967 1.84262 19.7267 -15.5304 +386 1 2.6809 7.4184 4.97144 1.84587 -3.02643 6.66108 +387 1 2.76451 6.5131 6.02372 26.4927 9.3308 7.09081 +388 1 1.89235 7.21971 6.07993 -5.61302 23.442 -46.1583 +389 1 3.56452 6.91614 5.29782 1.29026 -2.451 2.37678 +390 1 4.22056 7.80764 5.23329 -2.48711 -3.82055 1.83806 +391 1 4.29263 6.77471 6.12925 7.35038 5.5119 -5.7056 +392 1 2.85273 7.60961 6.07343 16.4578 1.27697 -7.39815 +393 1 4.81773 6.56695 4.97715 -1.40117 8.33727 3.10183 +394 1 5.78811 7.39325 5.43254 7.66799 3.74746 -17.7564 +395 1 5.91597 6.55237 6.07292 -10.3134 0.875812 3.19143 +396 1 5.1536 7.54901 6.2302 -8.62748 1.72241 13.4381 +397 1 6.84976 6.76387 5.09828 -3.19969 2.83039 -4.79256 +398 1 7.54117 7.72913 5.1763 -12.4453 -25.3207 -11.2598 +399 1 7.70324 6.72981 5.83369 -19.5261 3.79708 -10.3274 +400 1 6.77336 7.41197 5.93794 -9.93531 -0.946567 -12.2979 +401 1 8.22949 8.35705 6.76928 1.64244 -1.45449 1.77988 +402 1 0.72004 0.832942 6.72959 22.4465 -5.361 -6.29847 +403 1 0.883022 0.0931191 7.57241 -5.23405 -15.4407 -5.32038 +404 1 0.0468789 0.82113 7.48906 -16.6351 2.71194 14.972 +405 1 2.03902 8.21121 6.63645 7.11775 -8.1199 -7.72414 +406 1 2.8098 1.35985 6.35749 11.4457 2.58538 -2.95276 +407 1 2.39096 8.06897 7.6788 1.19633 7.68608 5.18448 +408 1 1.75996 0.580686 7.28683 6.89284 15.6237 4.36189 +409 1 3.24708 7.93738 6.98795 5.84043 19.9452 -24.3758 +410 1 4.23919 0.919929 6.46503 -1.07654 -9.91612 -5.08402 +411 1 3.90772 0.424381 7.41946 37.0812 -23.6824 -3.45202 +412 1 2.91871 0.505987 7.33506 -26.0302 7.74114 -11.0468 +413 1 4.92803 0.11282 7.09764 -8.28234 1.33652 -4.84063 +414 1 5.89475 1.0043 6.70526 7.29393 0.830325 27.9656 +415 1 5.8956 8.35718 7.44426 -3.02776 0.024361 13.8614 +416 1 4.71342 1.28665 7.29701 10.263 5.35948 11.5905 +417 1 6.8248 0.0574117 7.01961 11.7828 1.29904 -9.90689 +418 1 7.52034 1.04303 6.65362 -4.17639 -6.17679 3.43381 +419 1 7.73603 8.17986 7.79994 1.7859 4.36245 -17.9939 +420 1 7.13318 0.752429 7.78463 13.3591 3.5282 -5.71599 +421 1 8.39243 1.66394 6.67161 -0.134672 7.39125 4.10576 +422 1 0.854509 2.49412 6.65204 0.887161 -2.38052 0.586225 +423 1 1.18138 1.63924 7.31791 -41.6971 -18.352 25.0151 +424 1 0.0943458 2.334 7.66786 0.324396 10.57 -15.5201 +425 1 1.87867 1.74452 6.645 -1.95754 3.46436 -44.2754 +426 1 2.63684 2.47303 6.52845 -8.45632 -20.7999 4.28943 +427 1 2.51699 1.47554 7.37579 1.92109 3.65888 22.6814 +428 1 1.82876 2.39767 7.50566 14.4123 21.9409 0.136363 +429 1 3.78398 2.21463 6.57246 -2.68631 2.13236 -0.792617 +430 1 4.46308 3.07592 6.43555 -3.89191 7.33892 -9.13636 +431 1 3.59875 1.35397 7.20413 -9.98874 22.9069 2.08665 +432 1 3.19396 2.3577 7.56493 -2.6719 3.09783 -0.16421 +433 1 5.06299 2.1644 6.37533 -2.58633 -2.00836 2.79809 +434 1 5.67119 3.15784 6.34996 -0.566548 -6.83481 -5.10746 +435 1 5.66575 1.97666 7.57441 -14.7077 -20.3342 4.08546 +436 1 4.67442 2.64884 7.36908 -6.67424 -36.8328 0.644107 +437 1 6.68154 1.59605 7.24042 -18.9747 -1.14386 -19.0037 +438 1 7.52504 2.47849 6.70825 -1.30537 -8.16455 -5.2397 +439 1 7.60687 1.7083 7.61907 22.0172 -9.53549 -2.5479 +440 1 6.29708 2.66318 7.23348 12.1765 11.0009 -15.9537 +441 1 0.116615 3.32613 6.70965 -8.35482 -2.36763 -31.1169 +442 1 0.754871 4.30259 6.64315 -6.49201 3.33528 -9.76479 +443 1 0.673999 3.30917 7.54182 21.55 -11.008 11.6004 +444 1 8.2904 4.07274 7.4316 9.5379 25.3171 7.28976 +445 1 1.3832 3.4915 6.68441 -1.24784 -22.5622 2.29536 +446 1 2.09272 4.19927 6.89939 7.14914 10.3433 -0.646722 +447 1 2.38812 3.48925 7.75082 -1.53849 -4.15299 -0.56146 +448 1 0.98545 4.31304 7.66307 5.8465 7.34467 12.6645 +449 1 3.01955 3.30623 6.95327 13.2113 8.86686 7.49164 +450 1 4.09943 3.91395 7.09298 -2.48303 5.76893 1.33505 +451 1 4.01094 3.20608 7.89765 -2.70921 2.34384 1.12391 +452 1 3.37728 4.06259 7.97546 3.1883 6.31048 -16.9835 +453 1 4.95274 4.06193 6.44472 -50.262 -12.0969 -14.4258 +454 1 5.82886 4.19415 6.78586 51.8922 14.3443 21.8961 +455 1 5.38346 3.34165 7.34475 16.015 22.8896 8.36611 +456 1 5.08561 4.4601 7.63447 17.0994 -9.93497 -11.4722 +457 1 6.63523 3.51978 6.68288 11.156 -6.22589 -13.2585 +458 1 7.56324 4.26511 6.59456 -1.25309 2.63878 0.745103 +459 1 7.65852 3.28844 7.34661 -10.7372 -4.25374 3.64969 +460 1 6.81691 4.07739 7.53042 5.20496 31.087 -1.8792 +461 1 0.0305913 5.07954 6.63961 -13.4152 -0.334577 -15.0347 +462 1 0.755373 5.9128 6.63716 6.29428 -4.8245 9.83099 +463 1 0.228688 5.17338 7.63443 6.77209 -15.3569 2.77515 +464 1 0.0239769 6.1789 7.50959 5.71025 13.0173 8.45368 +465 1 1.62736 5.16876 6.26262 -1.95267 15.3222 16.2267 +466 1 2.58882 5.57631 6.81228 -21.3734 15.7914 -12.1527 +467 1 2.44828 4.86387 7.63128 0.635145 -14.9061 -0.714387 +468 1 1.59901 5.57209 7.51534 -11.1496 -3.28487 -5.03165 +469 1 3.34619 4.96263 7.08932 17.4571 -30.3367 -0.525226 +470 1 4.2543 5.71212 7.1129 9.72931 3.13017 -7.54215 +471 1 4.20945 4.90695 7.86069 -23.7666 -21.5851 -7.20856 +472 1 3.30097 5.87496 7.52978 -1.62077 18.6793 20.7743 +473 1 5.31869 5.1825 6.70313 -6.70115 -5.30598 20.424 +474 1 6.1285 5.9705 7.04356 -55.8752 -30.7828 -22.045 +475 1 6.19989 5.01385 7.64593 -24.2843 -27.8512 -0.0723503 +476 1 5.23737 5.71302 7.75618 7.88564 -2.82129 -5.95862 +477 1 6.57282 5.00818 6.64579 3.73801 7.56977 2.57742 +478 1 7.65968 6.07456 6.846 -10.6673 -6.72159 -16.2973 +479 1 7.41458 5.08419 7.34751 2.79575 -2.58892 1.26995 +480 1 6.72257 5.83109 7.80136 50.7146 16.6992 29.5346 +481 1 0.0723308 6.76891 6.47705 11.6111 8.10298 22.8191 +482 1 1.02933 7.74537 6.50218 -6.26193 -3.88943 1.15511 +483 1 0.947055 6.70337 7.58592 -5.51835 -14.0139 4.24362 +484 1 0.0848928 7.36532 7.45176 -1.87156 3.22591 1.0451 +485 1 1.56902 6.60766 6.76327 -14.013 -31.9293 15.0177 +486 1 2.40361 7.17234 6.95829 30.5527 12.991 8.35655 +487 1 2.29885 6.36291 7.58786 1.80834 5.53646 4.44151 +488 1 1.553 7.54602 7.43994 -8.27629 2.11355 -7.51923 +489 1 3.47111 6.73135 6.78593 -6.0772 1.66346 11.0677 +490 1 4.24975 7.49747 6.97664 2.8759 -9.15152 10.7243 +491 1 4.10179 6.68273 7.72108 -3.71491 1.8557 -11.1514 +492 1 3.18945 7.41445 7.81539 11.7129 -34.8369 22.2868 +493 1 5.09069 6.56162 6.92242 0.709322 1.72009 4.70344 +494 1 6.15914 7.53992 6.80488 -4.25562 -6.4834 8.29409 +495 1 6.17817 6.79535 7.72789 -19.4606 -0.130997 -26.8387 +496 1 5.10104 7.47088 7.65047 -2.76834 -2.47532 -11.4779 +497 1 6.74018 6.65599 6.74814 32.1985 25.9827 -14.7809 +498 1 7.41102 7.54832 6.72723 12.7336 -14.2037 26.5422 +499 1 7.28837 6.72521 7.66327 11.2322 2.95469 4.78999 +500 1 6.81386 7.67069 7.84231 -16.9841 5.08288 -4.95949 diff --git a/examples/mdi/log.17Jun22.aimd.alone.1 b/examples/mdi/log.17Jun22.aimd.alone.1 new file mode 100644 index 0000000000..c7b0f2c492 --- /dev/null +++ b/examples/mdi/log.17Jun22.aimd.alone.1 @@ -0,0 +1,95 @@ +LAMMPS (2 Jun 2022) +# 3d Lennard-Jones melt - MDI driver script + +variable x index 5 +variable y index 5 +variable z index 5 + +units lj +atom_style atomic + +lattice fcc 0.8442 +Lattice spacing in x,y,z = 1.6795962 1.6795962 1.6795962 +region box block 0 $x 0 $y 0 $z +region box block 0 5 0 $y 0 $z +region box block 0 5 0 5 0 $z +region box block 0 5 0 5 0 5 +create_box 1 box +Created orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) + 1 by 1 by 1 MPI processor grid +create_atoms 1 box +Created 500 atoms + using lattice units in orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) + create_atoms CPU = 0.001 seconds +mass 1 1.0 + +velocity all create 1.44 87287 loop geom + +pair_style lj/cut 2.5 +pair_coeff 1 1 1.0 1.0 2.5 + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +# NVE +fix 1 all nve +# NPT +#fix 1 all npt temp 1.0 1.0 0.1 iso 1.0 1.0 1.0 + +thermo_style custom step temp pe etotal press vol +thermo 1 + +run 10 +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 2.8 + ghost atom cutoff = 2.8 + binsize = 1.4, bins = 6 6 6 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair lj/cut, perpetual + attributes: half, newton on + pair build: half/bin/atomonly/newton + stencil: half/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 3.144 | 3.144 | 3.144 Mbytes + Step Temp PotEng TotEng Press Volume + 0 1.44 -6.7733681 -4.6176881 -5.0221006 592.27671 + 1 1.4377309 -6.7699814 -4.6176981 -5.0007431 592.27671 + 2 1.430825 -6.7596844 -4.6177394 -4.9363501 592.27671 + 3 1.4189655 -6.7420029 -4.6178116 -4.8276957 592.27671 + 4 1.4016029 -6.7161132 -4.6179137 -4.6726332 592.27671 + 5 1.3779738 -6.6808361 -4.6180094 -4.468186 592.27671 + 6 1.3471497 -6.6344152 -4.6177322 -4.2103477 592.27671 + 7 1.3081237 -6.5752633 -4.6170021 -3.8956402 592.27671 + 8 1.2599751 -6.502724 -4.6165412 -3.5228721 592.27671 + 9 1.2021373 -6.4153971 -4.6157975 -3.0910274 592.27671 + 10 1.1347688 -6.3153532 -4.6166043 -2.6072847 592.27671 +Loop time of 0.00919691 on 1 procs for 10 steps with 500 atoms + +Performance: 469723.136 tau/day, 1087.322 timesteps/s +98.9% CPU use with 1 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.0066536 | 0.0066536 | 0.0066536 | 0.0 | 72.35 +Neigh | 0.0017906 | 0.0017906 | 0.0017906 | 0.0 | 19.47 +Comm | 0.0002554 | 0.0002554 | 0.0002554 | 0.0 | 2.78 +Output | 0.00029976 | 0.00029976 | 0.00029976 | 0.0 | 3.26 +Modify | 9.8718e-05 | 9.8718e-05 | 9.8718e-05 | 0.0 | 1.07 +Other | | 9.887e-05 | | | 1.08 + +Nlocal: 500 ave 500 max 500 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 1956 ave 1956 max 1956 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 19396 ave 19396 max 19396 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 19396 +Ave neighs/atom = 38.792 +Neighbor list builds = 1 +Dangerous builds = 0 +Total wall time: 0:00:00 diff --git a/examples/mdi/log.17Jun22.aimd.driver.mpi.1 b/examples/mdi/log.17Jun22.aimd.driver.mpi.1 new file mode 100644 index 0000000000..e06ca0ada1 --- /dev/null +++ b/examples/mdi/log.17Jun22.aimd.driver.mpi.1 @@ -0,0 +1,83 @@ +LAMMPS (2 Jun 2022) +# 3d Lennard-Jones melt - MDI driver script + +variable x index 5 +variable y index 5 +variable z index 5 + +units lj +atom_style atomic + +lattice fcc 0.8442 +Lattice spacing in x,y,z = 1.6795962 1.6795962 1.6795962 +region box block 0 $x 0 $y 0 $z +region box block 0 5 0 $y 0 $z +region box block 0 5 0 5 0 $z +region box block 0 5 0 5 0 5 +create_box 1 box +Created orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) + 1 by 1 by 1 MPI processor grid +create_atoms 1 box +Created 500 atoms + using lattice units in orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) + create_atoms CPU = 0.001 seconds +mass 1 1.0 + +velocity all create 1.44 87287 loop geom + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +# NVE +fix 1 all nve +# NPT +#fix 1 all npt temp 1.0 1.0 0.1 iso 1.0 1.0 1.0 + +fix 2 all mdi/qm virial yes + +thermo_style custom step temp pe etotal press vol +thermo 1 + +run 10 +WARNING: No pairwise cutoff or binsize set. Atom sorting therefore disabled. (../atom.cpp:2127) +WARNING: Communication cutoff is 0.0. No ghost atoms will be generated. Atoms may get lost. (../comm_brick.cpp:210) +Per MPI rank memory allocation (min/avg/max) = 2.297 | 2.297 | 2.297 Mbytes + Step Temp PotEng TotEng Press Volume + 0 1.44 -6.7733681 -4.6176881 -5.0221006 592.27671 + 1 1.4377309 -6.7699814 -4.6176981 -5.0007431 592.27671 + 2 1.430825 -6.7596844 -4.6177394 -4.9363501 592.27671 + 3 1.4189655 -6.7420029 -4.6178116 -4.8276957 592.27671 + 4 1.4016029 -6.7161132 -4.6179137 -4.6726332 592.27671 + 5 1.3779738 -6.6808361 -4.6180094 -4.468186 592.27671 + 6 1.3471497 -6.6344152 -4.6177322 -4.2103477 592.27671 + 7 1.3081237 -6.5752633 -4.6170021 -3.8956402 592.27671 + 8 1.2599751 -6.502724 -4.6165412 -3.5228721 592.27671 + 9 1.2021373 -6.4153971 -4.6157975 -3.0910274 592.27671 + 10 1.1347688 -6.3153532 -4.6166043 -2.6072847 592.27671 +Loop time of 0.0078442 on 1 procs for 10 steps with 500 atoms + +Performance: 550725.026 tau/day, 1274.826 timesteps/s +99.4% CPU use with 1 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0 | 0 | 0 | 0.0 | 0.00 +Neigh | 1.592e-06 | 1.592e-06 | 1.592e-06 | 0.0 | 0.02 +Comm | 2.6703e-05 | 2.6703e-05 | 2.6703e-05 | 0.0 | 0.34 +Output | 0.00021168 | 0.00021168 | 0.00021168 | 0.0 | 2.70 +Modify | 0.0075488 | 0.0075488 | 0.0075488 | 0.0 | 96.23 +Other | | 5.544e-05 | | | 0.71 + +Nlocal: 500 ave 500 max 500 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 0 ave 0 max 0 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 0 ave 0 max 0 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 0 +Ave neighs/atom = 0 +Neighbor list builds = 1 +Dangerous builds = 0 +Total wall time: 0:00:00 diff --git a/examples/mdi/log.17Jun22.aimd.driver.mpi.3 b/examples/mdi/log.17Jun22.aimd.driver.mpi.3 new file mode 100644 index 0000000000..e2f228ca6c --- /dev/null +++ b/examples/mdi/log.17Jun22.aimd.driver.mpi.3 @@ -0,0 +1,83 @@ +LAMMPS (2 Jun 2022) +# 3d Lennard-Jones melt - MDI driver script + +variable x index 5 +variable y index 5 +variable z index 5 + +units lj +atom_style atomic + +lattice fcc 0.8442 +Lattice spacing in x,y,z = 1.6795962 1.6795962 1.6795962 +region box block 0 $x 0 $y 0 $z +region box block 0 5 0 $y 0 $z +region box block 0 5 0 5 0 $z +region box block 0 5 0 5 0 5 +create_box 1 box +Created orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) + 1 by 1 by 3 MPI processor grid +create_atoms 1 box +Created 500 atoms + using lattice units in orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) + create_atoms CPU = 0.001 seconds +mass 1 1.0 + +velocity all create 1.44 87287 loop geom + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +# NVE +fix 1 all nve +# NPT +#fix 1 all npt temp 1.0 1.0 0.1 iso 1.0 1.0 1.0 + +fix 2 all mdi/qm virial yes + +thermo_style custom step temp pe etotal press vol +thermo 1 + +run 10 +WARNING: No pairwise cutoff or binsize set. Atom sorting therefore disabled. (../atom.cpp:2127) +WARNING: Communication cutoff is 0.0. No ghost atoms will be generated. Atoms may get lost. (../comm_brick.cpp:210) +Per MPI rank memory allocation (min/avg/max) = 2.297 | 2.297 | 2.297 Mbytes + Step Temp PotEng TotEng Press Volume + 0 1.44 -6.7733681 -4.6176881 -5.0221006 592.27671 + 1 1.4377309 -6.7699814 -4.6176981 -5.0007431 592.27671 + 2 1.430825 -6.7596844 -4.6177394 -4.9363501 592.27671 + 3 1.4189655 -6.7420029 -4.6178116 -4.8276957 592.27671 + 4 1.4016029 -6.7161132 -4.6179137 -4.6726332 592.27671 + 5 1.3779738 -6.6808361 -4.6180094 -4.468186 592.27671 + 6 1.3471497 -6.6344152 -4.6177322 -4.2103477 592.27671 + 7 1.3081237 -6.5752633 -4.6170021 -3.8956402 592.27671 + 8 1.2599751 -6.502724 -4.6165412 -3.5228721 592.27671 + 9 1.2021373 -6.4153971 -4.6157975 -3.0910274 592.27671 + 10 1.1347688 -6.3153532 -4.6166043 -2.6072847 592.27671 +Loop time of 0.00523112 on 3 procs for 10 steps with 500 atoms + +Performance: 825827.658 tau/day, 1911.638 timesteps/s +98.8% CPU use with 3 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0 | 0 | 0 | 0.0 | 0.00 +Neigh | 5.95e-07 | 1.7073e-06 | 3.907e-06 | 0.0 | 0.03 +Comm | 3.8259e-05 | 6.2707e-05 | 7.5974e-05 | 0.0 | 1.20 +Output | 0.00017543 | 0.00021238 | 0.00028075 | 0.0 | 4.06 +Modify | 0.004815 | 0.0048289 | 0.0048521 | 0.0 | 92.31 +Other | | 0.0001254 | | | 2.40 + +Nlocal: 166.667 ave 176 max 150 min +Histogram: 1 0 0 0 0 0 0 0 0 2 +Nghost: 0 ave 0 max 0 min +Histogram: 3 0 0 0 0 0 0 0 0 0 +Neighs: 0 ave 0 max 0 min +Histogram: 3 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 0 +Ave neighs/atom = 0 +Neighbor list builds = 1 +Dangerous builds = 0 +Total wall time: 0:00:00 diff --git a/examples/mdi/log.17Jun22.aimd.driver.plugin.1 b/examples/mdi/log.17Jun22.aimd.driver.plugin.1 new file mode 100644 index 0000000000..73779fc350 --- /dev/null +++ b/examples/mdi/log.17Jun22.aimd.driver.plugin.1 @@ -0,0 +1,84 @@ +LAMMPS (2 Jun 2022) +# 3d Lennard-Jones melt - MDI driver script + +variable x index 5 +variable y index 5 +variable z index 5 + +units lj +atom_style atomic + +lattice fcc 0.8442 +Lattice spacing in x,y,z = 1.6795962 1.6795962 1.6795962 +region box block 0 $x 0 $y 0 $z +region box block 0 5 0 $y 0 $z +region box block 0 5 0 5 0 $z +region box block 0 5 0 5 0 5 +create_box 1 box +Created orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) + 1 by 1 by 1 MPI processor grid +create_atoms 1 box +Created 500 atoms + using lattice units in orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) + create_atoms CPU = 0.001 seconds +mass 1 1.0 + +velocity all create 1.44 87287 loop geom + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +# NVE +fix 1 all nve +# NPT +#fix 1 all npt temp 1.0 1.0 0.1 iso 1.0 1.0 1.0 + +fix 2 all mdi/qm virial yes + +thermo_style custom step temp pe etotal press vol +thermo 1 + +mdi plugin lammps mdi "-role ENGINE -name LMP2 -method LINK" infile in.aimd.engine extra "-log log.aimd.engine.plugin" command "run 10" +run 10 +WARNING: No pairwise cutoff or binsize set. Atom sorting therefore disabled. (../atom.cpp:2127) +WARNING: Communication cutoff is 0.0. No ghost atoms will be generated. Atoms may get lost. (../comm_brick.cpp:210) +Per MPI rank memory allocation (min/avg/max) = 2.297 | 2.297 | 2.297 Mbytes + Step Temp PotEng TotEng Press Volume + 0 1.44 -6.7733681 -4.6176881 -5.0221006 592.27671 + 1 1.4377309 -6.7699814 -4.6176981 -5.0007431 592.27671 + 2 1.430825 -6.7596844 -4.6177394 -4.9363501 592.27671 + 3 1.4189655 -6.7420029 -4.6178116 -4.8276957 592.27671 + 4 1.4016029 -6.7161132 -4.6179137 -4.6726332 592.27671 + 5 1.3779738 -6.6808361 -4.6180094 -4.468186 592.27671 + 6 1.3471497 -6.6344152 -4.6177322 -4.2103477 592.27671 + 7 1.3081237 -6.5752633 -4.6170021 -3.8956402 592.27671 + 8 1.2599751 -6.502724 -4.6165412 -3.5228721 592.27671 + 9 1.2021373 -6.4153971 -4.6157975 -3.0910274 592.27671 + 10 1.1347688 -6.3153532 -4.6166043 -2.6072847 592.27671 +Loop time of 0.00940117 on 1 procs for 10 steps with 500 atoms + +Performance: 459517.175 tau/day, 1063.697 timesteps/s +96.1% CPU use with 1 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0 | 0 | 0 | 0.0 | 0.00 +Neigh | 1.9e-06 | 1.9e-06 | 1.9e-06 | 0.0 | 0.02 +Comm | 3.0131e-05 | 3.0131e-05 | 3.0131e-05 | 0.0 | 0.32 +Output | 0.00030359 | 0.00030359 | 0.00030359 | 0.0 | 3.23 +Modify | 0.0090041 | 0.0090041 | 0.0090041 | 0.0 | 95.78 +Other | | 6.144e-05 | | | 0.65 + +Nlocal: 500 ave 500 max 500 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 0 ave 0 max 0 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 0 ave 0 max 0 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 0 +Ave neighs/atom = 0 +Neighbor list builds = 1 +Dangerous builds = 0 +Total wall time: 0:00:00 diff --git a/examples/mdi/log.17Jun22.aimd.driver.plugin.3 b/examples/mdi/log.17Jun22.aimd.driver.plugin.3 new file mode 100644 index 0000000000..7bb02f5f35 --- /dev/null +++ b/examples/mdi/log.17Jun22.aimd.driver.plugin.3 @@ -0,0 +1,84 @@ +LAMMPS (2 Jun 2022) +# 3d Lennard-Jones melt - MDI driver script + +variable x index 5 +variable y index 5 +variable z index 5 + +units lj +atom_style atomic + +lattice fcc 0.8442 +Lattice spacing in x,y,z = 1.6795962 1.6795962 1.6795962 +region box block 0 $x 0 $y 0 $z +region box block 0 5 0 $y 0 $z +region box block 0 5 0 5 0 $z +region box block 0 5 0 5 0 5 +create_box 1 box +Created orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) + 1 by 1 by 3 MPI processor grid +create_atoms 1 box +Created 500 atoms + using lattice units in orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) + create_atoms CPU = 0.001 seconds +mass 1 1.0 + +velocity all create 1.44 87287 loop geom + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +# NVE +fix 1 all nve +# NPT +#fix 1 all npt temp 1.0 1.0 0.1 iso 1.0 1.0 1.0 + +fix 2 all mdi/qm virial yes + +thermo_style custom step temp pe etotal press vol +thermo 1 + +mdi plugin lammps mdi "-role ENGINE -name LMP2 -method LINK" infile in.aimd.engine extra "-log log.aimd.engine.plugin" command "run 10" +run 10 +WARNING: No pairwise cutoff or binsize set. Atom sorting therefore disabled. (../atom.cpp:2127) +WARNING: Communication cutoff is 0.0. No ghost atoms will be generated. Atoms may get lost. (../comm_brick.cpp:210) +Per MPI rank memory allocation (min/avg/max) = 2.297 | 2.297 | 2.297 Mbytes + Step Temp PotEng TotEng Press Volume + 0 1.44 -6.7733681 -4.6176881 -5.0221006 592.27671 + 1 1.4377309 -6.7699814 -4.6176981 -5.0007431 592.27671 + 2 1.430825 -6.7596844 -4.6177394 -4.9363501 592.27671 + 3 1.4189655 -6.7420029 -4.6178116 -4.8276957 592.27671 + 4 1.4016029 -6.7161132 -4.6179137 -4.6726332 592.27671 + 5 1.3779738 -6.6808361 -4.6180094 -4.468186 592.27671 + 6 1.3471497 -6.6344152 -4.6177322 -4.2103477 592.27671 + 7 1.3081237 -6.5752633 -4.6170021 -3.8956402 592.27671 + 8 1.2599751 -6.502724 -4.6165412 -3.5228721 592.27671 + 9 1.2021373 -6.4153971 -4.6157975 -3.0910274 592.27671 + 10 1.1347688 -6.3153532 -4.6166043 -2.6072847 592.27671 +Loop time of 0.00613177 on 3 procs for 10 steps with 500 atoms + +Performance: 704527.327 tau/day, 1630.850 timesteps/s +99.2% CPU use with 3 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0 | 0 | 0 | 0.0 | 0.00 +Neigh | 7.93e-07 | 1.8723e-06 | 3.996e-06 | 0.0 | 0.03 +Comm | 4.4254e-05 | 7.4628e-05 | 9.321e-05 | 0.0 | 1.22 +Output | 0.00019476 | 0.00024309 | 0.00032745 | 0.0 | 3.96 +Modify | 0.005637 | 0.0056559 | 0.0056903 | 0.0 | 92.24 +Other | | 0.0001563 | | | 2.55 + +Nlocal: 166.667 ave 176 max 150 min +Histogram: 1 0 0 0 0 0 0 0 0 2 +Nghost: 0 ave 0 max 0 min +Histogram: 3 0 0 0 0 0 0 0 0 0 +Neighs: 0 ave 0 max 0 min +Histogram: 3 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 0 +Ave neighs/atom = 0 +Neighbor list builds = 1 +Dangerous builds = 0 +Total wall time: 0:00:00 diff --git a/examples/mdi/log.17Jun22.aimd.driver.tcp.1 b/examples/mdi/log.17Jun22.aimd.driver.tcp.1 new file mode 100644 index 0000000000..db7413cc9e --- /dev/null +++ b/examples/mdi/log.17Jun22.aimd.driver.tcp.1 @@ -0,0 +1,83 @@ +LAMMPS (2 Jun 2022) +# 3d Lennard-Jones melt - MDI driver script + +variable x index 5 +variable y index 5 +variable z index 5 + +units lj +atom_style atomic + +lattice fcc 0.8442 +Lattice spacing in x,y,z = 1.6795962 1.6795962 1.6795962 +region box block 0 $x 0 $y 0 $z +region box block 0 5 0 $y 0 $z +region box block 0 5 0 5 0 $z +region box block 0 5 0 5 0 5 +create_box 1 box +Created orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) + 1 by 1 by 1 MPI processor grid +create_atoms 1 box +Created 500 atoms + using lattice units in orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) + create_atoms CPU = 0.001 seconds +mass 1 1.0 + +velocity all create 1.44 87287 loop geom + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +# NVE +fix 1 all nve +# NPT +#fix 1 all npt temp 1.0 1.0 0.1 iso 1.0 1.0 1.0 + +fix 2 all mdi/qm virial yes + +thermo_style custom step temp pe etotal press vol +thermo 1 + +run 10 +WARNING: No pairwise cutoff or binsize set. Atom sorting therefore disabled. (../atom.cpp:2127) +WARNING: Communication cutoff is 0.0. No ghost atoms will be generated. Atoms may get lost. (../comm_brick.cpp:210) +Per MPI rank memory allocation (min/avg/max) = 2.297 | 2.297 | 2.297 Mbytes + Step Temp PotEng TotEng Press Volume + 0 1.44 -6.7733681 -4.6176881 -5.0221006 592.27671 + 1 1.4377309 -6.7699814 -4.6176981 -5.0007431 592.27671 + 2 1.430825 -6.7596844 -4.6177394 -4.9363501 592.27671 + 3 1.4189655 -6.7420029 -4.6178116 -4.8276957 592.27671 + 4 1.4016029 -6.7161132 -4.6179137 -4.6726332 592.27671 + 5 1.3779738 -6.6808361 -4.6180094 -4.468186 592.27671 + 6 1.3471497 -6.6344152 -4.6177322 -4.2103477 592.27671 + 7 1.3081237 -6.5752633 -4.6170021 -3.8956402 592.27671 + 8 1.2599751 -6.502724 -4.6165412 -3.5228721 592.27671 + 9 1.2021373 -6.4153971 -4.6157975 -3.0910274 592.27671 + 10 1.1347688 -6.3153532 -4.6166043 -2.6072847 592.27671 +Loop time of 2.41182 on 1 procs for 10 steps with 500 atoms + +Performance: 1791.180 tau/day, 4.146 timesteps/s +0.1% CPU use with 1 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0 | 0 | 0 | 0.0 | 0.00 +Neigh | 2.596e-06 | 2.596e-06 | 2.596e-06 | 0.0 | 0.00 +Comm | 4.9627e-05 | 4.9627e-05 | 4.9627e-05 | 0.0 | 0.00 +Output | 0.00063707 | 0.00063707 | 0.00063707 | 0.0 | 0.03 +Modify | 2.411 | 2.411 | 2.411 | 0.0 | 99.97 +Other | | 0.0001146 | | | 0.00 + +Nlocal: 500 ave 500 max 500 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 0 ave 0 max 0 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 0 ave 0 max 0 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 0 +Ave neighs/atom = 0 +Neighbor list builds = 1 +Dangerous builds = 0 +Total wall time: 0:00:02 diff --git a/examples/mdi/log.17Jun22.aimd.driver.tcp.3 b/examples/mdi/log.17Jun22.aimd.driver.tcp.3 new file mode 100644 index 0000000000..43910d1a25 --- /dev/null +++ b/examples/mdi/log.17Jun22.aimd.driver.tcp.3 @@ -0,0 +1,83 @@ +LAMMPS (2 Jun 2022) +# 3d Lennard-Jones melt - MDI driver script + +variable x index 5 +variable y index 5 +variable z index 5 + +units lj +atom_style atomic + +lattice fcc 0.8442 +Lattice spacing in x,y,z = 1.6795962 1.6795962 1.6795962 +region box block 0 $x 0 $y 0 $z +region box block 0 5 0 $y 0 $z +region box block 0 5 0 5 0 $z +region box block 0 5 0 5 0 5 +create_box 1 box +Created orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) + 1 by 1 by 3 MPI processor grid +create_atoms 1 box +Created 500 atoms + using lattice units in orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) + create_atoms CPU = 0.001 seconds +mass 1 1.0 + +velocity all create 1.44 87287 loop geom + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +# NVE +fix 1 all nve +# NPT +#fix 1 all npt temp 1.0 1.0 0.1 iso 1.0 1.0 1.0 + +fix 2 all mdi/qm virial yes + +thermo_style custom step temp pe etotal press vol +thermo 1 + +run 10 +WARNING: No pairwise cutoff or binsize set. Atom sorting therefore disabled. (../atom.cpp:2127) +WARNING: Communication cutoff is 0.0. No ghost atoms will be generated. Atoms may get lost. (../comm_brick.cpp:210) +Per MPI rank memory allocation (min/avg/max) = 2.297 | 2.297 | 2.297 Mbytes + Step Temp PotEng TotEng Press Volume + 0 1.44 -6.7733681 -4.6176881 -5.0221006 592.27671 + 1 1.4377309 -6.7699814 -4.6176981 -5.0007431 592.27671 + 2 1.430825 -6.7596844 -4.6177394 -4.9363501 592.27671 + 3 1.4189655 -6.7420029 -4.6178116 -4.8276957 592.27671 + 4 1.4016029 -6.7161132 -4.6179137 -4.6726332 592.27671 + 5 1.3779738 -6.6808361 -4.6180094 -4.468186 592.27671 + 6 1.3471497 -6.6344152 -4.6177322 -4.2103477 592.27671 + 7 1.3081237 -6.5752633 -4.6170021 -3.8956402 592.27671 + 8 1.2599751 -6.502724 -4.6165412 -3.5228721 592.27671 + 9 1.2021373 -6.4153971 -4.6157975 -3.0910274 592.27671 + 10 1.1347688 -6.3153532 -4.6166043 -2.6072847 592.27671 +Loop time of 2.39983 on 3 procs for 10 steps with 500 atoms + +Performance: 1800.127 tau/day, 4.167 timesteps/s +66.7% CPU use with 3 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0 | 0 | 0 | 0.0 | 0.00 +Neigh | 3.75e-07 | 1.3583e-06 | 2.574e-06 | 0.0 | 0.00 +Comm | 5.4167e-05 | 0.00010938 | 0.00015338 | 0.0 | 0.00 +Output | 0.00030885 | 0.00042099 | 0.00064497 | 0.0 | 0.02 +Modify | 2.3988 | 2.3989 | 2.3989 | 0.0 | 99.96 +Other | | 0.0004276 | | | 0.02 + +Nlocal: 166.667 ave 176 max 150 min +Histogram: 1 0 0 0 0 0 0 0 0 2 +Nghost: 0 ave 0 max 0 min +Histogram: 3 0 0 0 0 0 0 0 0 0 +Neighs: 0 ave 0 max 0 min +Histogram: 3 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 0 +Ave neighs/atom = 0 +Neighbor list builds = 1 +Dangerous builds = 0 +Total wall time: 0:00:03 diff --git a/examples/mdi/log.17Jun22.aimd.engine.mpi.1 b/examples/mdi/log.17Jun22.aimd.engine.mpi.1 new file mode 100644 index 0000000000..cb2e94c705 --- /dev/null +++ b/examples/mdi/log.17Jun22.aimd.engine.mpi.1 @@ -0,0 +1,55 @@ +LAMMPS (2 Jun 2022) +# 3d Lennard-Jones melt - MDI engine script + +units lj +atom_style atomic + +lattice fcc 1.0 +Lattice spacing in x,y,z = 1.5874011 1.5874011 1.5874011 +region box block 0 1 0 1 0 1 +create_box 1 box +Created orthogonal box = (0 0 0) to (1.5874011 1.5874011 1.5874011) + 1 by 1 by 1 MPI processor grid +mass 1 1.0 + +pair_style lj/cut 2.5 +pair_coeff 1 1 1.0 1.0 2.5 + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +thermo_style custom step temp pe etotal press vol +thermo 1 + +mdi engine +delete_atoms group all +Deleted 0 atoms, new total = 0 + 1 by 1 by 1 MPI processor grid +WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 2.8 + ghost atom cutoff = 2.8 + binsize = 1.4, bins = 6 6 6 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair lj/cut, perpetual + attributes: half, newton on + pair build: half/bin/atomonly/newton + stencil: half/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 3.144 | 3.144 | 3.144 Mbytes + Step Temp PotEng TotEng Press Volume + 0 0 -6.7733681 -6.7733681 -6.2353173 592.27671 + 1 0 -6.7699814 -6.7699814 -6.2120481 592.27671 + 2 0 -6.7596844 -6.7596844 -6.1418368 592.27671 + 3 0 -6.7420029 -6.7420029 -6.0231905 592.27671 + 4 0 -6.7161132 -6.7161132 -5.8534999 592.27671 + 5 0 -6.6808361 -6.6808361 -5.6291449 592.27671 + 6 0 -6.6344152 -6.6344152 -5.3453369 592.27671 + 7 0 -6.5752633 -6.5752633 -4.9977496 592.27671 + 8 0 -6.502724 -6.502724 -4.5844158 592.27671 + 9 0 -6.4153971 -6.4153971 -4.103842 592.27671 + 10 0 -6.3153532 -6.3153532 -3.5633405 592.27671 +Total wall time: 0:00:00 diff --git a/examples/mdi/log.17Jun22.aimd.engine.mpi.4 b/examples/mdi/log.17Jun22.aimd.engine.mpi.4 new file mode 100644 index 0000000000..6d390106ce --- /dev/null +++ b/examples/mdi/log.17Jun22.aimd.engine.mpi.4 @@ -0,0 +1,55 @@ +LAMMPS (2 Jun 2022) +# 3d Lennard-Jones melt - MDI engine script + +units lj +atom_style atomic + +lattice fcc 1.0 +Lattice spacing in x,y,z = 1.5874011 1.5874011 1.5874011 +region box block 0 1 0 1 0 1 +create_box 1 box +Created orthogonal box = (0 0 0) to (1.5874011 1.5874011 1.5874011) + 1 by 2 by 2 MPI processor grid +mass 1 1.0 + +pair_style lj/cut 2.5 +pair_coeff 1 1 1.0 1.0 2.5 + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +thermo_style custom step temp pe etotal press vol +thermo 1 + +mdi engine +delete_atoms group all +Deleted 0 atoms, new total = 0 + 1 by 2 by 2 MPI processor grid +WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 2.8 + ghost atom cutoff = 2.8 + binsize = 1.4, bins = 6 6 6 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair lj/cut, perpetual + attributes: half, newton on + pair build: half/bin/atomonly/newton + stencil: half/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 3.109 | 3.109 | 3.109 Mbytes + Step Temp PotEng TotEng Press Volume + 0 0 -6.7733681 -6.7733681 -6.2353173 592.27671 + 1 0 -6.7699814 -6.7699814 -6.2120481 592.27671 + 2 0 -6.7596844 -6.7596844 -6.1418368 592.27671 + 3 0 -6.7420029 -6.7420029 -6.0231905 592.27671 + 4 0 -6.7161132 -6.7161132 -5.8534999 592.27671 + 5 0 -6.6808361 -6.6808361 -5.6291449 592.27671 + 6 0 -6.6344152 -6.6344152 -5.3453369 592.27671 + 7 0 -6.5752633 -6.5752633 -4.9977496 592.27671 + 8 0 -6.502724 -6.502724 -4.5844158 592.27671 + 9 0 -6.4153971 -6.4153971 -4.103842 592.27671 + 10 0 -6.3153532 -6.3153532 -3.5633405 592.27671 +Total wall time: 0:00:00 diff --git a/examples/mdi/log.17Jun22.aimd.engine.plugin.1 b/examples/mdi/log.17Jun22.aimd.engine.plugin.1 new file mode 100644 index 0000000000..cb2e94c705 --- /dev/null +++ b/examples/mdi/log.17Jun22.aimd.engine.plugin.1 @@ -0,0 +1,55 @@ +LAMMPS (2 Jun 2022) +# 3d Lennard-Jones melt - MDI engine script + +units lj +atom_style atomic + +lattice fcc 1.0 +Lattice spacing in x,y,z = 1.5874011 1.5874011 1.5874011 +region box block 0 1 0 1 0 1 +create_box 1 box +Created orthogonal box = (0 0 0) to (1.5874011 1.5874011 1.5874011) + 1 by 1 by 1 MPI processor grid +mass 1 1.0 + +pair_style lj/cut 2.5 +pair_coeff 1 1 1.0 1.0 2.5 + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +thermo_style custom step temp pe etotal press vol +thermo 1 + +mdi engine +delete_atoms group all +Deleted 0 atoms, new total = 0 + 1 by 1 by 1 MPI processor grid +WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 2.8 + ghost atom cutoff = 2.8 + binsize = 1.4, bins = 6 6 6 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair lj/cut, perpetual + attributes: half, newton on + pair build: half/bin/atomonly/newton + stencil: half/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 3.144 | 3.144 | 3.144 Mbytes + Step Temp PotEng TotEng Press Volume + 0 0 -6.7733681 -6.7733681 -6.2353173 592.27671 + 1 0 -6.7699814 -6.7699814 -6.2120481 592.27671 + 2 0 -6.7596844 -6.7596844 -6.1418368 592.27671 + 3 0 -6.7420029 -6.7420029 -6.0231905 592.27671 + 4 0 -6.7161132 -6.7161132 -5.8534999 592.27671 + 5 0 -6.6808361 -6.6808361 -5.6291449 592.27671 + 6 0 -6.6344152 -6.6344152 -5.3453369 592.27671 + 7 0 -6.5752633 -6.5752633 -4.9977496 592.27671 + 8 0 -6.502724 -6.502724 -4.5844158 592.27671 + 9 0 -6.4153971 -6.4153971 -4.103842 592.27671 + 10 0 -6.3153532 -6.3153532 -3.5633405 592.27671 +Total wall time: 0:00:00 diff --git a/examples/mdi/log.17Jun22.aimd.engine.plugin.3 b/examples/mdi/log.17Jun22.aimd.engine.plugin.3 new file mode 100644 index 0000000000..cd227cffd0 --- /dev/null +++ b/examples/mdi/log.17Jun22.aimd.engine.plugin.3 @@ -0,0 +1,55 @@ +LAMMPS (2 Jun 2022) +# 3d Lennard-Jones melt - MDI engine script + +units lj +atom_style atomic + +lattice fcc 1.0 +Lattice spacing in x,y,z = 1.5874011 1.5874011 1.5874011 +region box block 0 1 0 1 0 1 +create_box 1 box +Created orthogonal box = (0 0 0) to (1.5874011 1.5874011 1.5874011) + 1 by 1 by 3 MPI processor grid +mass 1 1.0 + +pair_style lj/cut 2.5 +pair_coeff 1 1 1.0 1.0 2.5 + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +thermo_style custom step temp pe etotal press vol +thermo 1 + +mdi engine +delete_atoms group all +Deleted 0 atoms, new total = 0 + 1 by 1 by 3 MPI processor grid +WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 2.8 + ghost atom cutoff = 2.8 + binsize = 1.4, bins = 6 6 6 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair lj/cut, perpetual + attributes: half, newton on + pair build: half/bin/atomonly/newton + stencil: half/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 3.124 | 3.13 | 3.133 Mbytes + Step Temp PotEng TotEng Press Volume + 0 0 -6.7733681 -6.7733681 -6.2353173 592.27671 + 1 0 -6.7699814 -6.7699814 -6.2120481 592.27671 + 2 0 -6.7596844 -6.7596844 -6.1418368 592.27671 + 3 0 -6.7420029 -6.7420029 -6.0231905 592.27671 + 4 0 -6.7161132 -6.7161132 -5.8534999 592.27671 + 5 0 -6.6808361 -6.6808361 -5.6291449 592.27671 + 6 0 -6.6344152 -6.6344152 -5.3453369 592.27671 + 7 0 -6.5752633 -6.5752633 -4.9977496 592.27671 + 8 0 -6.502724 -6.502724 -4.5844158 592.27671 + 9 0 -6.4153971 -6.4153971 -4.103842 592.27671 + 10 0 -6.3153532 -6.3153532 -3.5633405 592.27671 +Total wall time: 0:00:00 diff --git a/examples/mdi/log.17Jun22.aimd.engine.tcp.1 b/examples/mdi/log.17Jun22.aimd.engine.tcp.1 new file mode 100644 index 0000000000..9b1ae4a9e1 --- /dev/null +++ b/examples/mdi/log.17Jun22.aimd.engine.tcp.1 @@ -0,0 +1,55 @@ +LAMMPS (2 Jun 2022) +# 3d Lennard-Jones melt - MDI engine script + +units lj +atom_style atomic + +lattice fcc 1.0 +Lattice spacing in x,y,z = 1.5874011 1.5874011 1.5874011 +region box block 0 1 0 1 0 1 +create_box 1 box +Created orthogonal box = (0 0 0) to (1.5874011 1.5874011 1.5874011) + 1 by 1 by 1 MPI processor grid +mass 1 1.0 + +pair_style lj/cut 2.5 +pair_coeff 1 1 1.0 1.0 2.5 + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +thermo_style custom step temp pe etotal press vol +thermo 1 + +mdi engine +delete_atoms group all +Deleted 0 atoms, new total = 0 + 1 by 1 by 1 MPI processor grid +WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 2.8 + ghost atom cutoff = 2.8 + binsize = 1.4, bins = 6 6 6 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair lj/cut, perpetual + attributes: half, newton on + pair build: half/bin/atomonly/newton + stencil: half/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 3.144 | 3.144 | 3.144 Mbytes + Step Temp PotEng TotEng Press Volume + 0 0 -6.7733681 -6.7733681 -6.2353173 592.27671 + 1 0 -6.7699814 -6.7699814 -6.2120481 592.27671 + 2 0 -6.7596844 -6.7596844 -6.1418368 592.27671 + 3 0 -6.7420029 -6.7420029 -6.0231905 592.27671 + 4 0 -6.7161132 -6.7161132 -5.8534999 592.27671 + 5 0 -6.6808361 -6.6808361 -5.6291449 592.27671 + 6 0 -6.6344152 -6.6344152 -5.3453369 592.27671 + 7 0 -6.5752633 -6.5752633 -4.9977496 592.27671 + 8 0 -6.502724 -6.502724 -4.5844158 592.27671 + 9 0 -6.4153971 -6.4153971 -4.103842 592.27671 + 10 0 -6.3153532 -6.3153532 -3.5633405 592.27671 +Total wall time: 0:00:02 diff --git a/examples/mdi/log.17Jun22.aimd.engine.tcp.4 b/examples/mdi/log.17Jun22.aimd.engine.tcp.4 new file mode 100644 index 0000000000..7bca369d96 --- /dev/null +++ b/examples/mdi/log.17Jun22.aimd.engine.tcp.4 @@ -0,0 +1,55 @@ +LAMMPS (2 Jun 2022) +# 3d Lennard-Jones melt - MDI engine script + +units lj +atom_style atomic + +lattice fcc 1.0 +Lattice spacing in x,y,z = 1.5874011 1.5874011 1.5874011 +region box block 0 1 0 1 0 1 +create_box 1 box +Created orthogonal box = (0 0 0) to (1.5874011 1.5874011 1.5874011) + 1 by 2 by 2 MPI processor grid +mass 1 1.0 + +pair_style lj/cut 2.5 +pair_coeff 1 1 1.0 1.0 2.5 + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +thermo_style custom step temp pe etotal press vol +thermo 1 + +mdi engine +delete_atoms group all +Deleted 0 atoms, new total = 0 + 1 by 2 by 2 MPI processor grid +WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 2.8 + ghost atom cutoff = 2.8 + binsize = 1.4, bins = 6 6 6 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair lj/cut, perpetual + attributes: half, newton on + pair build: half/bin/atomonly/newton + stencil: half/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 3.109 | 3.109 | 3.109 Mbytes + Step Temp PotEng TotEng Press Volume + 0 0 -6.7733681 -6.7733681 -6.2353173 592.27671 + 1 0 -6.7699814 -6.7699814 -6.2120481 592.27671 + 2 0 -6.7596844 -6.7596844 -6.1418368 592.27671 + 3 0 -6.7420029 -6.7420029 -6.0231905 592.27671 + 4 0 -6.7161132 -6.7161132 -5.8534999 592.27671 + 5 0 -6.6808361 -6.6808361 -5.6291449 592.27671 + 6 0 -6.6344152 -6.6344152 -5.3453369 592.27671 + 7 0 -6.5752633 -6.5752633 -4.9977496 592.27671 + 8 0 -6.502724 -6.502724 -4.5844158 592.27671 + 9 0 -6.4153971 -6.4153971 -4.103842 592.27671 + 10 0 -6.3153532 -6.3153532 -3.5633405 592.27671 +Total wall time: 0:00:02 diff --git a/examples/mdi/log.17Jun22.aimdpy.driver.mpi.1 b/examples/mdi/log.17Jun22.aimdpy.driver.mpi.1 new file mode 100644 index 0000000000..c0e8df8217 --- /dev/null +++ b/examples/mdi/log.17Jun22.aimdpy.driver.mpi.1 @@ -0,0 +1,77 @@ +LAMMPS (2 Jun 2022) +LAMMPS (2 Jun 2022) +Lattice spacing in x,y,z = 1.6795962 1.6795962 1.6795962 +Created orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) + 1 by 1 by 1 MPI processor grid +Created 500 atoms + using lattice units in orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) + create_atoms CPU = 0.000 seconds +Lattice spacing in x,y,z = 1.6795962 1.6795962 1.6795962 +Created orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) + 1 by 1 by 1 MPI processor grid +Created 500 atoms + using lattice units in orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) + create_atoms CPU = 0.001 seconds +Setting up Verlet run ... + Unit style : lj + Current step : 0 + Time step : 0.005 +WARNING: No pairwise cutoff or binsize set. Atom sorting therefore disabled. (../atom.cpp:2127) +WARNING: Communication cutoff is 0.0. No ghost atoms will be generated. Atoms may get lost. (../comm_brick.cpp:210) +WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 2.8 + ghost atom cutoff = 2.8 + binsize = 1.4, bins = 6 6 6 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair lj/cut, perpetual + attributes: half, newton on + pair build: half/bin/atomonly/newton + stencil: half/bin/3d + bin: standard +Setting up Verlet run ... + Unit style : lj + Current step : 0 + Time step : 0.005 +Per MPI rank memory allocation (min/avg/max) = 3.144 | 3.144 | 3.144 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 0 -6.7733681 0 -6.7733681 -6.2353173 +Step 0: MM energy 2.15568, QM energy -6.77337, Total energy -4.61769 +Per MPI rank memory allocation (min/avg/max) = 2.297 | 2.297 | 2.297 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 1.44 0 0 2.15568 1.2132167 + 1 0 -6.7699814 0 -6.7699814 -6.2120481 +Step 1: MM energy 2.15228, QM energy -6.76998, Total energy -4.6177 + 1 1.4377309 0 0 2.1522832 1.211305 + 2 0 -6.7596844 0 -6.7596844 -6.1418368 +Step 2: MM energy 2.14195, QM energy -6.75968, Total energy -4.61774 + 2 1.430825 0 0 2.141945 1.2054866 + 3 0 -6.7420029 0 -6.7420029 -6.0231905 +Step 3: MM energy 2.12419, QM energy -6.742, Total energy -4.61781 + 3 1.4189655 0 0 2.1241913 1.1954949 + 4 0 -6.7161132 0 -6.7161132 -5.8534999 +Step 4: MM energy 2.0982, QM energy -6.71611, Total energy -4.61791 + 4 1.4016029 0 0 2.0981995 1.1808667 + 5 0 -6.6808361 0 -6.6808361 -5.6291449 +Step 5: MM energy 2.06283, QM energy -6.68084, Total energy -4.61801 + 5 1.3779738 0 0 2.0628267 1.1609589 + 6 0 -6.6344152 0 -6.6344152 -5.3453369 +Step 6: MM energy 2.01668, QM energy -6.63442, Total energy -4.61773 + 6 1.3471497 0 0 2.016683 1.1349892 + 7 0 -6.5752633 0 -6.5752633 -4.9977496 +Step 7: MM energy 1.95826, QM energy -6.57526, Total energy -4.617 + 7 1.3081237 0 0 1.9582612 1.1021094 + 8 0 -6.502724 0 -6.502724 -4.5844158 +Step 8: MM energy 1.88618, QM energy -6.50272, Total energy -4.61654 + 8 1.2599751 0 0 1.8861828 1.0615437 + 9 0 -6.4153971 0 -6.4153971 -4.103842 +Step 9: MM energy 1.7996, QM energy -6.4154, Total energy -4.6158 + 9 1.2021373 0 0 1.7995995 1.0128146 + 10 0 -6.3153532 0 -6.3153532 -3.5633405 +Step 10: MM energy 1.69875, QM energy -6.31535, Total energy -4.6166 + 10 1.1347688 0 0 1.6987489 0.95605588 +Total wall time: 0:00:00 +Total wall time: 0:00:00 diff --git a/examples/mdi/log.17Jun22.aimdpy.driver.mpi.2 b/examples/mdi/log.17Jun22.aimdpy.driver.mpi.2 new file mode 100644 index 0000000000..7c839dc2d4 --- /dev/null +++ b/examples/mdi/log.17Jun22.aimdpy.driver.mpi.2 @@ -0,0 +1,77 @@ +LAMMPS (2 Jun 2022) +LAMMPS (2 Jun 2022) +Lattice spacing in x,y,z = 1.6795962 1.6795962 1.6795962 +Created orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) + 1 by 1 by 2 MPI processor grid +Created 500 atoms + using lattice units in orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) + create_atoms CPU = 0.000 seconds +Lattice spacing in x,y,z = 1.6795962 1.6795962 1.6795962 +Created orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) + 1 by 1 by 3 MPI processor grid +Created 500 atoms + using lattice units in orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) + create_atoms CPU = 0.001 seconds +Setting up Verlet run ... + Unit style : lj + Current step : 0 + Time step : 0.005 +WARNING: No pairwise cutoff or binsize set. Atom sorting therefore disabled. (../atom.cpp:2127) +WARNING: Communication cutoff is 0.0. No ghost atoms will be generated. Atoms may get lost. (../comm_brick.cpp:210) +WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 2.8 + ghost atom cutoff = 2.8 + binsize = 1.4, bins = 6 6 6 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair lj/cut, perpetual + attributes: half, newton on + pair build: half/bin/atomonly/newton + stencil: half/bin/3d + bin: standard +Setting up Verlet run ... + Unit style : lj + Current step : 0 + Time step : 0.005 +Per MPI rank memory allocation (min/avg/max) = 3.124 | 3.13 | 3.133 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 0 -6.7733681 0 -6.7733681 -6.2353173 +Step 0: MM energy 2.15568, QM energy -6.77337, Total energy -4.61769 +Per MPI rank memory allocation (min/avg/max) = 2.297 | 2.297 | 2.297 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 1.44 0 0 2.15568 1.2132167 + 1 0 -6.7699814 0 -6.7699814 -6.2120481 +Step 1: MM energy 2.15228, QM energy -6.76998, Total energy -4.6177 + 1 1.4377309 0 0 2.1522832 1.211305 + 2 0 -6.7596844 0 -6.7596844 -6.1418368 +Step 2: MM energy 2.14195, QM energy -6.75968, Total energy -4.61774 + 2 1.430825 0 0 2.141945 1.2054866 + 3 0 -6.7420029 0 -6.7420029 -6.0231905 +Step 3: MM energy 2.12419, QM energy -6.742, Total energy -4.61781 + 3 1.4189655 0 0 2.1241913 1.1954949 + 4 0 -6.7161132 0 -6.7161132 -5.8534999 +Step 4: MM energy 2.0982, QM energy -6.71611, Total energy -4.61791 + 4 1.4016029 0 0 2.0981995 1.1808667 + 5 0 -6.6808361 0 -6.6808361 -5.6291449 +Step 5: MM energy 2.06283, QM energy -6.68084, Total energy -4.61801 + 5 1.3779738 0 0 2.0628267 1.1609589 + 6 0 -6.6344152 0 -6.6344152 -5.3453369 +Step 6: MM energy 2.01668, QM energy -6.63442, Total energy -4.61773 + 6 1.3471497 0 0 2.016683 1.1349892 + 7 0 -6.5752633 0 -6.5752633 -4.9977496 +Step 7: MM energy 1.95826, QM energy -6.57526, Total energy -4.617 + 7 1.3081237 0 0 1.9582612 1.1021094 + 8 0 -6.502724 0 -6.502724 -4.5844158 +Step 8: MM energy 1.88618, QM energy -6.50272, Total energy -4.61654 + 8 1.2599751 0 0 1.8861828 1.0615437 + 9 0 -6.4153971 0 -6.4153971 -4.103842 +Step 9: MM energy 1.7996, QM energy -6.4154, Total energy -4.6158 + 9 1.2021373 0 0 1.7995995 1.0128146 + 10 0 -6.3153532 0 -6.3153532 -3.5633405 +Step 10: MM energy 1.69875, QM energy -6.31535, Total energy -4.6166 + 10 1.1347688 0 0 1.6987489 0.95605588 +Total wall time: 0:00:00 +Total wall time: 0:00:00 diff --git a/examples/mdi/log.17Jun22.aimdpy.driver.tcp.1 b/examples/mdi/log.17Jun22.aimdpy.driver.tcp.1 new file mode 100644 index 0000000000..6ae0d7b714 --- /dev/null +++ b/examples/mdi/log.17Jun22.aimdpy.driver.tcp.1 @@ -0,0 +1,11 @@ +Step 0: MM energy 2.15568, QM energy -6.77337, Total energy -4.61769 +Step 1: MM energy 2.15228, QM energy -6.76998, Total energy -4.6177 +Step 2: MM energy 2.14195, QM energy -6.75968, Total energy -4.61774 +Step 3: MM energy 2.12419, QM energy -6.742, Total energy -4.61781 +Step 4: MM energy 2.0982, QM energy -6.71611, Total energy -4.61791 +Step 5: MM energy 2.06283, QM energy -6.68084, Total energy -4.61801 +Step 6: MM energy 2.01668, QM energy -6.63442, Total energy -4.61773 +Step 7: MM energy 1.95826, QM energy -6.57526, Total energy -4.617 +Step 8: MM energy 1.88618, QM energy -6.50272, Total energy -4.61654 +Step 9: MM energy 1.7996, QM energy -6.4154, Total energy -4.6158 +Step 10: MM energy 1.69875, QM energy -6.31535, Total energy -4.6166 diff --git a/examples/mdi/log.17Jun22.aimdpy.driver.tcp.2 b/examples/mdi/log.17Jun22.aimdpy.driver.tcp.2 new file mode 100644 index 0000000000..6ae0d7b714 --- /dev/null +++ b/examples/mdi/log.17Jun22.aimdpy.driver.tcp.2 @@ -0,0 +1,11 @@ +Step 0: MM energy 2.15568, QM energy -6.77337, Total energy -4.61769 +Step 1: MM energy 2.15228, QM energy -6.76998, Total energy -4.6177 +Step 2: MM energy 2.14195, QM energy -6.75968, Total energy -4.61774 +Step 3: MM energy 2.12419, QM energy -6.742, Total energy -4.61781 +Step 4: MM energy 2.0982, QM energy -6.71611, Total energy -4.61791 +Step 5: MM energy 2.06283, QM energy -6.68084, Total energy -4.61801 +Step 6: MM energy 2.01668, QM energy -6.63442, Total energy -4.61773 +Step 7: MM energy 1.95826, QM energy -6.57526, Total energy -4.617 +Step 8: MM energy 1.88618, QM energy -6.50272, Total energy -4.61654 +Step 9: MM energy 1.7996, QM energy -6.4154, Total energy -4.6158 +Step 10: MM energy 1.69875, QM energy -6.31535, Total energy -4.6166 diff --git a/examples/mdi/log.17Jun22.aimdpy.mm.mpi.1 b/examples/mdi/log.17Jun22.aimdpy.mm.mpi.1 new file mode 100644 index 0000000000..2b9251e6fd --- /dev/null +++ b/examples/mdi/log.17Jun22.aimdpy.mm.mpi.1 @@ -0,0 +1,49 @@ +LAMMPS (2 Jun 2022) +# 3d Lennard-Jones melt - LAMMPS as MM engine for aimd_driver.py + +variable x index 5 +variable y index 5 +variable z index 5 + +units lj +atom_style atomic + +lattice fcc 0.8442 +Lattice spacing in x,y,z = 1.6795962 1.6795962 1.6795962 +region box block 0 $x 0 $y 0 $z +region box block 0 5 0 $y 0 $z +region box block 0 5 0 5 0 $z +region box block 0 5 0 5 0 5 +create_box 1 box +Created orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) + 1 by 1 by 1 MPI processor grid +create_atoms 1 box +Created 500 atoms + using lattice units in orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) + create_atoms CPU = 0.001 seconds +mass 1 1.0 + +velocity all create 1.44 87287 loop geom + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +fix 1 all nve + +mdi engine +WARNING: No pairwise cutoff or binsize set. Atom sorting therefore disabled. (../atom.cpp:2127) +WARNING: Communication cutoff is 0.0. No ghost atoms will be generated. Atoms may get lost. (../comm_brick.cpp:210) +Per MPI rank memory allocation (min/avg/max) = 2.297 | 2.297 | 2.297 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 1.44 0 0 2.15568 1.2132167 + 1 1.4377309 0 0 2.1522832 1.211305 + 2 1.430825 0 0 2.141945 1.2054866 + 3 1.4189655 0 0 2.1241913 1.1954949 + 4 1.4016029 0 0 2.0981995 1.1808667 + 5 1.3779738 0 0 2.0628267 1.1609589 + 6 1.3471497 0 0 2.016683 1.1349892 + 7 1.3081237 0 0 1.9582612 1.1021094 + 8 1.2599751 0 0 1.8861828 1.0615437 + 9 1.2021373 0 0 1.7995995 1.0128146 + 10 1.1347688 0 0 1.6987489 0.95605588 +Total wall time: 0:00:00 diff --git a/examples/mdi/log.17Jun22.aimdpy.mm.mpi.2 b/examples/mdi/log.17Jun22.aimdpy.mm.mpi.2 new file mode 100644 index 0000000000..cb46801dac --- /dev/null +++ b/examples/mdi/log.17Jun22.aimdpy.mm.mpi.2 @@ -0,0 +1,49 @@ +LAMMPS (2 Jun 2022) +# 3d Lennard-Jones melt - LAMMPS as MM engine for aimd_driver.py + +variable x index 5 +variable y index 5 +variable z index 5 + +units lj +atom_style atomic + +lattice fcc 0.8442 +Lattice spacing in x,y,z = 1.6795962 1.6795962 1.6795962 +region box block 0 $x 0 $y 0 $z +region box block 0 5 0 $y 0 $z +region box block 0 5 0 5 0 $z +region box block 0 5 0 5 0 5 +create_box 1 box +Created orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) + 1 by 1 by 2 MPI processor grid +create_atoms 1 box +Created 500 atoms + using lattice units in orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) + create_atoms CPU = 0.000 seconds +mass 1 1.0 + +velocity all create 1.44 87287 loop geom + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +fix 1 all nve + +mdi engine +WARNING: No pairwise cutoff or binsize set. Atom sorting therefore disabled. (../atom.cpp:2127) +WARNING: Communication cutoff is 0.0. No ghost atoms will be generated. Atoms may get lost. (../comm_brick.cpp:210) +Per MPI rank memory allocation (min/avg/max) = 2.297 | 2.297 | 2.297 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 1.44 0 0 2.15568 1.2132167 + 1 1.4377309 0 0 2.1522832 1.211305 + 2 1.430825 0 0 2.141945 1.2054866 + 3 1.4189655 0 0 2.1241913 1.1954949 + 4 1.4016029 0 0 2.0981995 1.1808667 + 5 1.3779738 0 0 2.0628267 1.1609589 + 6 1.3471497 0 0 2.016683 1.1349892 + 7 1.3081237 0 0 1.9582612 1.1021094 + 8 1.2599751 0 0 1.8861828 1.0615437 + 9 1.2021373 0 0 1.7995995 1.0128146 + 10 1.1347688 0 0 1.6987489 0.95605588 +Total wall time: 0:00:00 diff --git a/examples/mdi/log.17Jun22.aimdpy.mm.tcp.1 b/examples/mdi/log.17Jun22.aimdpy.mm.tcp.1 new file mode 100644 index 0000000000..a23fcbac53 --- /dev/null +++ b/examples/mdi/log.17Jun22.aimdpy.mm.tcp.1 @@ -0,0 +1,49 @@ +LAMMPS (2 Jun 2022) +# 3d Lennard-Jones melt - LAMMPS as MM engine for aimd_driver.py + +variable x index 5 +variable y index 5 +variable z index 5 + +units lj +atom_style atomic + +lattice fcc 0.8442 +Lattice spacing in x,y,z = 1.6795962 1.6795962 1.6795962 +region box block 0 $x 0 $y 0 $z +region box block 0 5 0 $y 0 $z +region box block 0 5 0 5 0 $z +region box block 0 5 0 5 0 5 +create_box 1 box +Created orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) + 1 by 1 by 1 MPI processor grid +create_atoms 1 box +Created 500 atoms + using lattice units in orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) + create_atoms CPU = 0.001 seconds +mass 1 1.0 + +velocity all create 1.44 87287 loop geom + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +fix 1 all nve + +mdi engine +WARNING: No pairwise cutoff or binsize set. Atom sorting therefore disabled. (../atom.cpp:2127) +WARNING: Communication cutoff is 0.0. No ghost atoms will be generated. Atoms may get lost. (../comm_brick.cpp:210) +Per MPI rank memory allocation (min/avg/max) = 2.297 | 2.297 | 2.297 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 1.44 0 0 2.15568 1.2132167 + 1 1.4377309 0 0 2.1522832 1.211305 + 2 1.430825 0 0 2.141945 1.2054866 + 3 1.4189655 0 0 2.1241913 1.1954949 + 4 1.4016029 0 0 2.0981995 1.1808667 + 5 1.3779738 0 0 2.0628267 1.1609589 + 6 1.3471497 0 0 2.016683 1.1349892 + 7 1.3081237 0 0 1.9582612 1.1021094 + 8 1.2599751 0 0 1.8861828 1.0615437 + 9 1.2021373 0 0 1.7995995 1.0128146 + 10 1.1347688 0 0 1.6987489 0.95605588 +Total wall time: 0:00:02 diff --git a/examples/mdi/log.17Jun22.aimdpy.mm.tcp.2 b/examples/mdi/log.17Jun22.aimdpy.mm.tcp.2 new file mode 100644 index 0000000000..fab47d094f --- /dev/null +++ b/examples/mdi/log.17Jun22.aimdpy.mm.tcp.2 @@ -0,0 +1,49 @@ +LAMMPS (2 Jun 2022) +# 3d Lennard-Jones melt - LAMMPS as MM engine for aimd_driver.py + +variable x index 5 +variable y index 5 +variable z index 5 + +units lj +atom_style atomic + +lattice fcc 0.8442 +Lattice spacing in x,y,z = 1.6795962 1.6795962 1.6795962 +region box block 0 $x 0 $y 0 $z +region box block 0 5 0 $y 0 $z +region box block 0 5 0 5 0 $z +region box block 0 5 0 5 0 5 +create_box 1 box +Created orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) + 1 by 1 by 2 MPI processor grid +create_atoms 1 box +Created 500 atoms + using lattice units in orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) + create_atoms CPU = 0.001 seconds +mass 1 1.0 + +velocity all create 1.44 87287 loop geom + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +fix 1 all nve + +mdi engine +WARNING: No pairwise cutoff or binsize set. Atom sorting therefore disabled. (../atom.cpp:2127) +WARNING: Communication cutoff is 0.0. No ghost atoms will be generated. Atoms may get lost. (../comm_brick.cpp:210) +Per MPI rank memory allocation (min/avg/max) = 2.297 | 2.297 | 2.297 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 1.44 0 0 2.15568 1.2132167 + 1 1.4377309 0 0 2.1522832 1.211305 + 2 1.430825 0 0 2.141945 1.2054866 + 3 1.4189655 0 0 2.1241913 1.1954949 + 4 1.4016029 0 0 2.0981995 1.1808667 + 5 1.3779738 0 0 2.0628267 1.1609589 + 6 1.3471497 0 0 2.016683 1.1349892 + 7 1.3081237 0 0 1.9582612 1.1021094 + 8 1.2599751 0 0 1.8861828 1.0615437 + 9 1.2021373 0 0 1.7995995 1.0128146 + 10 1.1347688 0 0 1.6987489 0.95605588 +Total wall time: 0:00:02 diff --git a/examples/mdi/log.17Jun22.aimdpy.qm.mpi.1 b/examples/mdi/log.17Jun22.aimdpy.qm.mpi.1 new file mode 100644 index 0000000000..f365e18542 --- /dev/null +++ b/examples/mdi/log.17Jun22.aimdpy.qm.mpi.1 @@ -0,0 +1,60 @@ +LAMMPS (2 Jun 2022) +# 3d Lennard-Jones melt - LAMMPS as surrogate QM engine for aimd_driver.py + +variable x index 5 +variable y index 5 +variable z index 5 + +units lj +atom_style atomic + +lattice fcc 0.8442 +Lattice spacing in x,y,z = 1.6795962 1.6795962 1.6795962 +region box block 0 $x 0 $y 0 $z +region box block 0 5 0 $y 0 $z +region box block 0 5 0 5 0 $z +region box block 0 5 0 5 0 5 +create_box 1 box +Created orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) + 1 by 1 by 1 MPI processor grid +create_atoms 1 box +Created 500 atoms + using lattice units in orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) + create_atoms CPU = 0.000 seconds +mass 1 1.0 + +pair_style lj/cut 2.5 +pair_coeff 1 1 1.0 1.0 2.5 + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +mdi engine +WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 2.8 + ghost atom cutoff = 2.8 + binsize = 1.4, bins = 6 6 6 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair lj/cut, perpetual + attributes: half, newton on + pair build: half/bin/atomonly/newton + stencil: half/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 3.144 | 3.144 | 3.144 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 0 -6.7733681 0 -6.7733681 -6.2353173 + 1 0 -6.7699814 0 -6.7699814 -6.2120481 + 2 0 -6.7596844 0 -6.7596844 -6.1418368 + 3 0 -6.7420029 0 -6.7420029 -6.0231905 + 4 0 -6.7161132 0 -6.7161132 -5.8534999 + 5 0 -6.6808361 0 -6.6808361 -5.6291449 + 6 0 -6.6344152 0 -6.6344152 -5.3453369 + 7 0 -6.5752633 0 -6.5752633 -4.9977496 + 8 0 -6.502724 0 -6.502724 -4.5844158 + 9 0 -6.4153971 0 -6.4153971 -4.103842 + 10 0 -6.3153532 0 -6.3153532 -3.5633405 +Total wall time: 0:00:00 diff --git a/examples/mdi/log.17Jun22.aimdpy.qm.mpi.3 b/examples/mdi/log.17Jun22.aimdpy.qm.mpi.3 new file mode 100644 index 0000000000..87501440b7 --- /dev/null +++ b/examples/mdi/log.17Jun22.aimdpy.qm.mpi.3 @@ -0,0 +1,60 @@ +LAMMPS (2 Jun 2022) +# 3d Lennard-Jones melt - LAMMPS as surrogate QM engine for aimd_driver.py + +variable x index 5 +variable y index 5 +variable z index 5 + +units lj +atom_style atomic + +lattice fcc 0.8442 +Lattice spacing in x,y,z = 1.6795962 1.6795962 1.6795962 +region box block 0 $x 0 $y 0 $z +region box block 0 5 0 $y 0 $z +region box block 0 5 0 5 0 $z +region box block 0 5 0 5 0 5 +create_box 1 box +Created orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) + 1 by 1 by 3 MPI processor grid +create_atoms 1 box +Created 500 atoms + using lattice units in orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) + create_atoms CPU = 0.001 seconds +mass 1 1.0 + +pair_style lj/cut 2.5 +pair_coeff 1 1 1.0 1.0 2.5 + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +mdi engine +WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 2.8 + ghost atom cutoff = 2.8 + binsize = 1.4, bins = 6 6 6 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair lj/cut, perpetual + attributes: half, newton on + pair build: half/bin/atomonly/newton + stencil: half/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 3.124 | 3.13 | 3.133 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 0 -6.7733681 0 -6.7733681 -6.2353173 + 1 0 -6.7699814 0 -6.7699814 -6.2120481 + 2 0 -6.7596844 0 -6.7596844 -6.1418368 + 3 0 -6.7420029 0 -6.7420029 -6.0231905 + 4 0 -6.7161132 0 -6.7161132 -5.8534999 + 5 0 -6.6808361 0 -6.6808361 -5.6291449 + 6 0 -6.6344152 0 -6.6344152 -5.3453369 + 7 0 -6.5752633 0 -6.5752633 -4.9977496 + 8 0 -6.502724 0 -6.502724 -4.5844158 + 9 0 -6.4153971 0 -6.4153971 -4.103842 + 10 0 -6.3153532 0 -6.3153532 -3.5633405 +Total wall time: 0:00:00 diff --git a/examples/mdi/log.17Jun22.aimdpy.qm.tcp.1 b/examples/mdi/log.17Jun22.aimdpy.qm.tcp.1 new file mode 100644 index 0000000000..1dd64c4beb --- /dev/null +++ b/examples/mdi/log.17Jun22.aimdpy.qm.tcp.1 @@ -0,0 +1,60 @@ +LAMMPS (2 Jun 2022) +# 3d Lennard-Jones melt - LAMMPS as surrogate QM engine for aimd_driver.py + +variable x index 5 +variable y index 5 +variable z index 5 + +units lj +atom_style atomic + +lattice fcc 0.8442 +Lattice spacing in x,y,z = 1.6795962 1.6795962 1.6795962 +region box block 0 $x 0 $y 0 $z +region box block 0 5 0 $y 0 $z +region box block 0 5 0 5 0 $z +region box block 0 5 0 5 0 5 +create_box 1 box +Created orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) + 1 by 1 by 1 MPI processor grid +create_atoms 1 box +Created 500 atoms + using lattice units in orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) + create_atoms CPU = 0.001 seconds +mass 1 1.0 + +pair_style lj/cut 2.5 +pair_coeff 1 1 1.0 1.0 2.5 + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +mdi engine +WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 2.8 + ghost atom cutoff = 2.8 + binsize = 1.4, bins = 6 6 6 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair lj/cut, perpetual + attributes: half, newton on + pair build: half/bin/atomonly/newton + stencil: half/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 3.144 | 3.144 | 3.144 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 0 -6.7733681 0 -6.7733681 -6.2353173 + 1 0 -6.7699814 0 -6.7699814 -6.2120481 + 2 0 -6.7596844 0 -6.7596844 -6.1418368 + 3 0 -6.7420029 0 -6.7420029 -6.0231905 + 4 0 -6.7161132 0 -6.7161132 -5.8534999 + 5 0 -6.6808361 0 -6.6808361 -5.6291449 + 6 0 -6.6344152 0 -6.6344152 -5.3453369 + 7 0 -6.5752633 0 -6.5752633 -4.9977496 + 8 0 -6.502724 0 -6.502724 -4.5844158 + 9 0 -6.4153971 0 -6.4153971 -4.103842 + 10 0 -6.3153532 0 -6.3153532 -3.5633405 +Total wall time: 0:00:02 diff --git a/examples/mdi/log.17Jun22.aimdpy.qm.tcp.3 b/examples/mdi/log.17Jun22.aimdpy.qm.tcp.3 new file mode 100644 index 0000000000..2006741b75 --- /dev/null +++ b/examples/mdi/log.17Jun22.aimdpy.qm.tcp.3 @@ -0,0 +1,60 @@ +LAMMPS (2 Jun 2022) +# 3d Lennard-Jones melt - LAMMPS as surrogate QM engine for aimd_driver.py + +variable x index 5 +variable y index 5 +variable z index 5 + +units lj +atom_style atomic + +lattice fcc 0.8442 +Lattice spacing in x,y,z = 1.6795962 1.6795962 1.6795962 +region box block 0 $x 0 $y 0 $z +region box block 0 5 0 $y 0 $z +region box block 0 5 0 5 0 $z +region box block 0 5 0 5 0 5 +create_box 1 box +Created orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) + 1 by 1 by 3 MPI processor grid +create_atoms 1 box +Created 500 atoms + using lattice units in orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) + create_atoms CPU = 0.001 seconds +mass 1 1.0 + +pair_style lj/cut 2.5 +pair_coeff 1 1 1.0 1.0 2.5 + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +mdi engine +WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 2.8 + ghost atom cutoff = 2.8 + binsize = 1.4, bins = 6 6 6 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair lj/cut, perpetual + attributes: half, newton on + pair build: half/bin/atomonly/newton + stencil: half/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 3.124 | 3.13 | 3.133 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 0 -6.7733681 0 -6.7733681 -6.2353173 + 1 0 -6.7699814 0 -6.7699814 -6.2120481 + 2 0 -6.7596844 0 -6.7596844 -6.1418368 + 3 0 -6.7420029 0 -6.7420029 -6.0231905 + 4 0 -6.7161132 0 -6.7161132 -5.8534999 + 5 0 -6.6808361 0 -6.6808361 -5.6291449 + 6 0 -6.6344152 0 -6.6344152 -5.3453369 + 7 0 -6.5752633 0 -6.5752633 -4.9977496 + 8 0 -6.502724 0 -6.502724 -4.5844158 + 9 0 -6.4153971 0 -6.4153971 -4.103842 + 10 0 -6.3153532 0 -6.3153532 -3.5633405 +Total wall time: 0:00:02 diff --git a/examples/mdi/log.17Jun22.sequence.engine.mpi.1 b/examples/mdi/log.17Jun22.sequence.engine.mpi.1 new file mode 100644 index 0000000000..78a5fe3cb6 --- /dev/null +++ b/examples/mdi/log.17Jun22.sequence.engine.mpi.1 @@ -0,0 +1,90 @@ +LAMMPS (2 Jun 2022) +# MDI engine script to process a series of evaulate, run, minimize commands + +units lj +atom_style atomic + +lattice fcc 0.8442 +Lattice spacing in x,y,z = 1.6795962 1.6795962 1.6795962 +region box block 0 1 0 1 0 1 +create_box 1 box +Created orthogonal box = (0 0 0) to (1.6795962 1.6795962 1.6795962) + 1 by 1 by 1 MPI processor grid +mass 1 1.0 + +pair_style lj/cut 2.5 +pair_coeff 1 1 1.0 1.0 2.5 + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +fix 1 all nve + +thermo 10 + +mdi engine +delete_atoms group all +Deleted 0 atoms, new total = 0 + 1 by 1 by 1 MPI processor grid +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 2.8 + ghost atom cutoff = 2.8 + binsize = 1.4, bins = 4 4 4 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair lj/cut, perpetual + attributes: half, newton on + pair build: half/bin/atomonly/newton + stencil: half/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 3.077 | 3.077 | 3.077 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 1 -3.9713146 0 -2.4947521 3.1253597 + 10 1.2380002 -4.3210346 0 -2.4930499 2.0015258 + 20 1.173596 -4.2234559 0 -2.4905682 2.3587731 + 30 1.2989994 -4.4124445 0 -2.4943907 1.903698 + 40 1.4510255 -4.6467459 0 -2.504216 1.2196259 + 50 1.4631454 -4.6641774 0 -2.5037518 1.2838406 + 60 1.2694188 -4.3794267 0 -2.5050505 2.4497113 + 70 1.3363814 -4.4759884 0 -2.5027378 2.2441463 + 80 1.402534 -4.5752515 0 -2.5043224 1.9011715 + 90 1.3870321 -4.5512479 0 -2.5032084 2.0040237 + 100 1.3635651 -4.5209384 0 -2.5075493 1.9773816 +delete_atoms group all +Deleted 64 atoms, new total = 0 + 1 by 1 by 1 MPI processor grid +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Per MPI rank memory allocation (min/avg/max) = 3.077 | 3.077 | 3.077 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 1 -4.1934138 0 -2.7168513 0.72358299 + 10 1.0170498 -4.2225288 0 -2.7207912 0.7556766 + 20 0.92567967 -4.0920979 0 -2.725274 1.2463143 + 30 1.0851758 -4.3346599 0 -2.73233 0.53176652 + 40 1.2163699 -4.5351986 0 -2.7391524 -0.077915153 + 50 1.2305739 -4.5558134 0 -2.7387942 -0.10711153 + 60 1.1172288 -4.3979372 0 -2.7482791 0.52752067 + 70 1.2228415 -4.5540741 0 -2.7484722 0.11937533 + 80 1.1776333 -4.4870195 0 -2.7481704 0.33904864 + 90 1.219283 -4.5483185 0 -2.747971 0.17898549 + 100 1.2138939 -4.5432229 0 -2.7508327 0.3076354 +delete_atoms group all +Deleted 64 atoms, new total = 0 + 1 by 1 by 1 MPI processor grid +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Per MPI rank memory allocation (min/avg/max) = 3.077 | 3.077 | 3.077 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 1 -3.8524214 0 -2.3758589 4.6814052 + 10 1.3356745 -4.3481612 0 -2.3759544 3.061856 + 20 1.1791601 -4.117932 0 -2.3768284 3.8565 + 30 1.3435556 -4.3613609 0 -2.3775171 3.0728735 + 40 1.5628445 -4.6886004 0 -2.3809628 2.0989245 + 50 1.4735556 -4.5569123 0 -2.3811152 2.6364099 + 60 1.609387 -4.7581056 0 -2.3817452 1.8988642 + 70 1.5014902 -4.5938759 0 -2.3768318 2.458161 + 80 1.3763383 -4.4089865 0 -2.3767369 3.0379808 + 90 1.498202 -4.5909613 0 -2.3787724 2.5543714 + 100 1.43934 -4.5009545 0 -2.375679 3.0923444 + +Total wall time: 0:00:00 diff --git a/examples/mdi/log.17Jun22.sequence.engine.mpi.4 b/examples/mdi/log.17Jun22.sequence.engine.mpi.4 new file mode 100644 index 0000000000..856166696c --- /dev/null +++ b/examples/mdi/log.17Jun22.sequence.engine.mpi.4 @@ -0,0 +1,90 @@ +LAMMPS (2 Jun 2022) +# MDI engine script to process a series of evaulate, run, minimize commands + +units lj +atom_style atomic + +lattice fcc 0.8442 +Lattice spacing in x,y,z = 1.6795962 1.6795962 1.6795962 +region box block 0 1 0 1 0 1 +create_box 1 box +Created orthogonal box = (0 0 0) to (1.6795962 1.6795962 1.6795962) + 1 by 2 by 2 MPI processor grid +mass 1 1.0 + +pair_style lj/cut 2.5 +pair_coeff 1 1 1.0 1.0 2.5 + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +fix 1 all nve + +thermo 10 + +mdi engine +delete_atoms group all +Deleted 0 atoms, new total = 0 + 1 by 2 by 2 MPI processor grid +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 2.8 + ghost atom cutoff = 2.8 + binsize = 1.4, bins = 4 4 4 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair lj/cut, perpetual + attributes: half, newton on + pair build: half/bin/atomonly/newton + stencil: half/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 3.077 | 3.077 | 3.077 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 1 -3.9713146 0 -2.4947521 3.1253597 + 10 1.2380002 -4.3210346 0 -2.4930499 2.0015258 + 20 1.173596 -4.2234559 0 -2.4905682 2.3587731 + 30 1.2989994 -4.4124445 0 -2.4943907 1.903698 + 40 1.4510255 -4.6467459 0 -2.504216 1.2196259 + 50 1.4631454 -4.6641774 0 -2.5037518 1.2838406 + 60 1.2694188 -4.3794267 0 -2.5050505 2.4497113 + 70 1.3363814 -4.4759884 0 -2.5027378 2.2441463 + 80 1.402534 -4.5752515 0 -2.5043224 1.9011715 + 90 1.3870321 -4.5512479 0 -2.5032084 2.0040237 + 100 1.3635651 -4.5209384 0 -2.5075493 1.9773816 +delete_atoms group all +Deleted 64 atoms, new total = 0 + 1 by 2 by 2 MPI processor grid +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Per MPI rank memory allocation (min/avg/max) = 3.077 | 3.077 | 3.077 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 1 -4.1934138 0 -2.7168513 0.72358299 + 10 1.0170498 -4.2225288 0 -2.7207912 0.7556766 + 20 0.92567967 -4.0920979 0 -2.725274 1.2463143 + 30 1.0851758 -4.3346599 0 -2.73233 0.53176652 + 40 1.2163699 -4.5351986 0 -2.7391524 -0.077915153 + 50 1.2305739 -4.5558134 0 -2.7387942 -0.10711153 + 60 1.1172288 -4.3979372 0 -2.7482791 0.52752067 + 70 1.2228415 -4.5540741 0 -2.7484722 0.11937533 + 80 1.1776333 -4.4870195 0 -2.7481704 0.33904864 + 90 1.219283 -4.5483185 0 -2.747971 0.17898549 + 100 1.2138939 -4.5432229 0 -2.7508327 0.3076354 +delete_atoms group all +Deleted 64 atoms, new total = 0 + 1 by 2 by 2 MPI processor grid +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Per MPI rank memory allocation (min/avg/max) = 3.077 | 3.077 | 3.077 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 1 -3.8524214 0 -2.3758589 4.6814052 + 10 1.3356745 -4.3481612 0 -2.3759544 3.061856 + 20 1.1791601 -4.117932 0 -2.3768284 3.8565 + 30 1.3435556 -4.3613609 0 -2.3775171 3.0728735 + 40 1.5628445 -4.6886004 0 -2.3809628 2.0989245 + 50 1.4735556 -4.5569123 0 -2.3811152 2.6364099 + 60 1.609387 -4.7581056 0 -2.3817452 1.8988642 + 70 1.5014902 -4.5938759 0 -2.3768318 2.458161 + 80 1.3763383 -4.4089865 0 -2.3767369 3.0379808 + 90 1.498202 -4.5909613 0 -2.3787724 2.5543714 + 100 1.43934 -4.5009545 0 -2.375679 3.0923444 + +Total wall time: 0:00:00 diff --git a/examples/mdi/log.17Jun22.sequence.engine.plugin.1 b/examples/mdi/log.17Jun22.sequence.engine.plugin.1 new file mode 100644 index 0000000000..78a5fe3cb6 --- /dev/null +++ b/examples/mdi/log.17Jun22.sequence.engine.plugin.1 @@ -0,0 +1,90 @@ +LAMMPS (2 Jun 2022) +# MDI engine script to process a series of evaulate, run, minimize commands + +units lj +atom_style atomic + +lattice fcc 0.8442 +Lattice spacing in x,y,z = 1.6795962 1.6795962 1.6795962 +region box block 0 1 0 1 0 1 +create_box 1 box +Created orthogonal box = (0 0 0) to (1.6795962 1.6795962 1.6795962) + 1 by 1 by 1 MPI processor grid +mass 1 1.0 + +pair_style lj/cut 2.5 +pair_coeff 1 1 1.0 1.0 2.5 + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +fix 1 all nve + +thermo 10 + +mdi engine +delete_atoms group all +Deleted 0 atoms, new total = 0 + 1 by 1 by 1 MPI processor grid +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 2.8 + ghost atom cutoff = 2.8 + binsize = 1.4, bins = 4 4 4 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair lj/cut, perpetual + attributes: half, newton on + pair build: half/bin/atomonly/newton + stencil: half/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 3.077 | 3.077 | 3.077 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 1 -3.9713146 0 -2.4947521 3.1253597 + 10 1.2380002 -4.3210346 0 -2.4930499 2.0015258 + 20 1.173596 -4.2234559 0 -2.4905682 2.3587731 + 30 1.2989994 -4.4124445 0 -2.4943907 1.903698 + 40 1.4510255 -4.6467459 0 -2.504216 1.2196259 + 50 1.4631454 -4.6641774 0 -2.5037518 1.2838406 + 60 1.2694188 -4.3794267 0 -2.5050505 2.4497113 + 70 1.3363814 -4.4759884 0 -2.5027378 2.2441463 + 80 1.402534 -4.5752515 0 -2.5043224 1.9011715 + 90 1.3870321 -4.5512479 0 -2.5032084 2.0040237 + 100 1.3635651 -4.5209384 0 -2.5075493 1.9773816 +delete_atoms group all +Deleted 64 atoms, new total = 0 + 1 by 1 by 1 MPI processor grid +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Per MPI rank memory allocation (min/avg/max) = 3.077 | 3.077 | 3.077 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 1 -4.1934138 0 -2.7168513 0.72358299 + 10 1.0170498 -4.2225288 0 -2.7207912 0.7556766 + 20 0.92567967 -4.0920979 0 -2.725274 1.2463143 + 30 1.0851758 -4.3346599 0 -2.73233 0.53176652 + 40 1.2163699 -4.5351986 0 -2.7391524 -0.077915153 + 50 1.2305739 -4.5558134 0 -2.7387942 -0.10711153 + 60 1.1172288 -4.3979372 0 -2.7482791 0.52752067 + 70 1.2228415 -4.5540741 0 -2.7484722 0.11937533 + 80 1.1776333 -4.4870195 0 -2.7481704 0.33904864 + 90 1.219283 -4.5483185 0 -2.747971 0.17898549 + 100 1.2138939 -4.5432229 0 -2.7508327 0.3076354 +delete_atoms group all +Deleted 64 atoms, new total = 0 + 1 by 1 by 1 MPI processor grid +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Per MPI rank memory allocation (min/avg/max) = 3.077 | 3.077 | 3.077 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 1 -3.8524214 0 -2.3758589 4.6814052 + 10 1.3356745 -4.3481612 0 -2.3759544 3.061856 + 20 1.1791601 -4.117932 0 -2.3768284 3.8565 + 30 1.3435556 -4.3613609 0 -2.3775171 3.0728735 + 40 1.5628445 -4.6886004 0 -2.3809628 2.0989245 + 50 1.4735556 -4.5569123 0 -2.3811152 2.6364099 + 60 1.609387 -4.7581056 0 -2.3817452 1.8988642 + 70 1.5014902 -4.5938759 0 -2.3768318 2.458161 + 80 1.3763383 -4.4089865 0 -2.3767369 3.0379808 + 90 1.498202 -4.5909613 0 -2.3787724 2.5543714 + 100 1.43934 -4.5009545 0 -2.375679 3.0923444 + +Total wall time: 0:00:00 diff --git a/examples/mdi/log.17Jun22.sequence.engine.plugin.3 b/examples/mdi/log.17Jun22.sequence.engine.plugin.3 new file mode 100644 index 0000000000..4cb140028a --- /dev/null +++ b/examples/mdi/log.17Jun22.sequence.engine.plugin.3 @@ -0,0 +1,90 @@ +LAMMPS (2 Jun 2022) +# MDI engine script to process a series of evaulate, run, minimize commands + +units lj +atom_style atomic + +lattice fcc 0.8442 +Lattice spacing in x,y,z = 1.6795962 1.6795962 1.6795962 +region box block 0 1 0 1 0 1 +create_box 1 box +Created orthogonal box = (0 0 0) to (1.6795962 1.6795962 1.6795962) + 1 by 1 by 3 MPI processor grid +mass 1 1.0 + +pair_style lj/cut 2.5 +pair_coeff 1 1 1.0 1.0 2.5 + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +fix 1 all nve + +thermo 10 + +mdi engine +delete_atoms group all +Deleted 0 atoms, new total = 0 + 1 by 1 by 3 MPI processor grid +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 2.8 + ghost atom cutoff = 2.8 + binsize = 1.4, bins = 4 4 4 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair lj/cut, perpetual + attributes: half, newton on + pair build: half/bin/atomonly/newton + stencil: half/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 3.07 | 3.07 | 3.071 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 1 -3.9713146 0 -2.4947521 3.1253597 + 10 1.2380002 -4.3210346 0 -2.4930499 2.0015258 + 20 1.173596 -4.2234559 0 -2.4905682 2.3587731 + 30 1.2989994 -4.4124445 0 -2.4943907 1.903698 + 40 1.4510255 -4.6467459 0 -2.504216 1.2196259 + 50 1.4631454 -4.6641774 0 -2.5037518 1.2838406 + 60 1.2694188 -4.3794267 0 -2.5050505 2.4497113 + 70 1.3363814 -4.4759884 0 -2.5027378 2.2441463 + 80 1.402534 -4.5752515 0 -2.5043224 1.9011715 + 90 1.3870321 -4.5512479 0 -2.5032084 2.0040237 + 100 1.3635651 -4.5209384 0 -2.5075493 1.9773816 +delete_atoms group all +Deleted 64 atoms, new total = 0 + 1 by 1 by 3 MPI processor grid +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Per MPI rank memory allocation (min/avg/max) = 3.07 | 3.07 | 3.071 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 1 -4.1934138 0 -2.7168513 0.72358299 + 10 1.0170498 -4.2225288 0 -2.7207912 0.7556766 + 20 0.92567967 -4.0920979 0 -2.725274 1.2463143 + 30 1.0851758 -4.3346599 0 -2.73233 0.53176652 + 40 1.2163699 -4.5351986 0 -2.7391524 -0.077915153 + 50 1.2305739 -4.5558134 0 -2.7387942 -0.10711153 + 60 1.1172288 -4.3979372 0 -2.7482791 0.52752067 + 70 1.2228415 -4.5540741 0 -2.7484722 0.11937533 + 80 1.1776333 -4.4870195 0 -2.7481704 0.33904864 + 90 1.219283 -4.5483185 0 -2.747971 0.17898549 + 100 1.2138939 -4.5432229 0 -2.7508327 0.3076354 +delete_atoms group all +Deleted 64 atoms, new total = 0 + 3 by 1 by 1 MPI processor grid +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Per MPI rank memory allocation (min/avg/max) = 3.07 | 3.07 | 3.071 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 1 -3.8524214 0 -2.3758589 4.6814052 + 10 1.3356745 -4.3481612 0 -2.3759544 3.061856 + 20 1.1791601 -4.117932 0 -2.3768284 3.8565 + 30 1.3435556 -4.3613609 0 -2.3775171 3.0728735 + 40 1.5628445 -4.6886004 0 -2.3809628 2.0989245 + 50 1.4735556 -4.5569123 0 -2.3811152 2.6364099 + 60 1.609387 -4.7581056 0 -2.3817452 1.8988642 + 70 1.5014902 -4.5938759 0 -2.3768318 2.458161 + 80 1.3763383 -4.4089865 0 -2.3767369 3.0379808 + 90 1.498202 -4.5909613 0 -2.3787724 2.5543714 + 100 1.43934 -4.5009545 0 -2.375679 3.0923444 + +Total wall time: 0:00:00 diff --git a/examples/mdi/log.17Jun22.sequence.engine.tcp.1 b/examples/mdi/log.17Jun22.sequence.engine.tcp.1 new file mode 100644 index 0000000000..78a5fe3cb6 --- /dev/null +++ b/examples/mdi/log.17Jun22.sequence.engine.tcp.1 @@ -0,0 +1,90 @@ +LAMMPS (2 Jun 2022) +# MDI engine script to process a series of evaulate, run, minimize commands + +units lj +atom_style atomic + +lattice fcc 0.8442 +Lattice spacing in x,y,z = 1.6795962 1.6795962 1.6795962 +region box block 0 1 0 1 0 1 +create_box 1 box +Created orthogonal box = (0 0 0) to (1.6795962 1.6795962 1.6795962) + 1 by 1 by 1 MPI processor grid +mass 1 1.0 + +pair_style lj/cut 2.5 +pair_coeff 1 1 1.0 1.0 2.5 + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +fix 1 all nve + +thermo 10 + +mdi engine +delete_atoms group all +Deleted 0 atoms, new total = 0 + 1 by 1 by 1 MPI processor grid +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 2.8 + ghost atom cutoff = 2.8 + binsize = 1.4, bins = 4 4 4 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair lj/cut, perpetual + attributes: half, newton on + pair build: half/bin/atomonly/newton + stencil: half/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 3.077 | 3.077 | 3.077 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 1 -3.9713146 0 -2.4947521 3.1253597 + 10 1.2380002 -4.3210346 0 -2.4930499 2.0015258 + 20 1.173596 -4.2234559 0 -2.4905682 2.3587731 + 30 1.2989994 -4.4124445 0 -2.4943907 1.903698 + 40 1.4510255 -4.6467459 0 -2.504216 1.2196259 + 50 1.4631454 -4.6641774 0 -2.5037518 1.2838406 + 60 1.2694188 -4.3794267 0 -2.5050505 2.4497113 + 70 1.3363814 -4.4759884 0 -2.5027378 2.2441463 + 80 1.402534 -4.5752515 0 -2.5043224 1.9011715 + 90 1.3870321 -4.5512479 0 -2.5032084 2.0040237 + 100 1.3635651 -4.5209384 0 -2.5075493 1.9773816 +delete_atoms group all +Deleted 64 atoms, new total = 0 + 1 by 1 by 1 MPI processor grid +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Per MPI rank memory allocation (min/avg/max) = 3.077 | 3.077 | 3.077 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 1 -4.1934138 0 -2.7168513 0.72358299 + 10 1.0170498 -4.2225288 0 -2.7207912 0.7556766 + 20 0.92567967 -4.0920979 0 -2.725274 1.2463143 + 30 1.0851758 -4.3346599 0 -2.73233 0.53176652 + 40 1.2163699 -4.5351986 0 -2.7391524 -0.077915153 + 50 1.2305739 -4.5558134 0 -2.7387942 -0.10711153 + 60 1.1172288 -4.3979372 0 -2.7482791 0.52752067 + 70 1.2228415 -4.5540741 0 -2.7484722 0.11937533 + 80 1.1776333 -4.4870195 0 -2.7481704 0.33904864 + 90 1.219283 -4.5483185 0 -2.747971 0.17898549 + 100 1.2138939 -4.5432229 0 -2.7508327 0.3076354 +delete_atoms group all +Deleted 64 atoms, new total = 0 + 1 by 1 by 1 MPI processor grid +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Per MPI rank memory allocation (min/avg/max) = 3.077 | 3.077 | 3.077 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 1 -3.8524214 0 -2.3758589 4.6814052 + 10 1.3356745 -4.3481612 0 -2.3759544 3.061856 + 20 1.1791601 -4.117932 0 -2.3768284 3.8565 + 30 1.3435556 -4.3613609 0 -2.3775171 3.0728735 + 40 1.5628445 -4.6886004 0 -2.3809628 2.0989245 + 50 1.4735556 -4.5569123 0 -2.3811152 2.6364099 + 60 1.609387 -4.7581056 0 -2.3817452 1.8988642 + 70 1.5014902 -4.5938759 0 -2.3768318 2.458161 + 80 1.3763383 -4.4089865 0 -2.3767369 3.0379808 + 90 1.498202 -4.5909613 0 -2.3787724 2.5543714 + 100 1.43934 -4.5009545 0 -2.375679 3.0923444 + +Total wall time: 0:00:00 diff --git a/examples/mdi/log.17Jun22.sequence.engine.tcp.4 b/examples/mdi/log.17Jun22.sequence.engine.tcp.4 new file mode 100644 index 0000000000..856166696c --- /dev/null +++ b/examples/mdi/log.17Jun22.sequence.engine.tcp.4 @@ -0,0 +1,90 @@ +LAMMPS (2 Jun 2022) +# MDI engine script to process a series of evaulate, run, minimize commands + +units lj +atom_style atomic + +lattice fcc 0.8442 +Lattice spacing in x,y,z = 1.6795962 1.6795962 1.6795962 +region box block 0 1 0 1 0 1 +create_box 1 box +Created orthogonal box = (0 0 0) to (1.6795962 1.6795962 1.6795962) + 1 by 2 by 2 MPI processor grid +mass 1 1.0 + +pair_style lj/cut 2.5 +pair_coeff 1 1 1.0 1.0 2.5 + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +fix 1 all nve + +thermo 10 + +mdi engine +delete_atoms group all +Deleted 0 atoms, new total = 0 + 1 by 2 by 2 MPI processor grid +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 2.8 + ghost atom cutoff = 2.8 + binsize = 1.4, bins = 4 4 4 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair lj/cut, perpetual + attributes: half, newton on + pair build: half/bin/atomonly/newton + stencil: half/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 3.077 | 3.077 | 3.077 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 1 -3.9713146 0 -2.4947521 3.1253597 + 10 1.2380002 -4.3210346 0 -2.4930499 2.0015258 + 20 1.173596 -4.2234559 0 -2.4905682 2.3587731 + 30 1.2989994 -4.4124445 0 -2.4943907 1.903698 + 40 1.4510255 -4.6467459 0 -2.504216 1.2196259 + 50 1.4631454 -4.6641774 0 -2.5037518 1.2838406 + 60 1.2694188 -4.3794267 0 -2.5050505 2.4497113 + 70 1.3363814 -4.4759884 0 -2.5027378 2.2441463 + 80 1.402534 -4.5752515 0 -2.5043224 1.9011715 + 90 1.3870321 -4.5512479 0 -2.5032084 2.0040237 + 100 1.3635651 -4.5209384 0 -2.5075493 1.9773816 +delete_atoms group all +Deleted 64 atoms, new total = 0 + 1 by 2 by 2 MPI processor grid +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Per MPI rank memory allocation (min/avg/max) = 3.077 | 3.077 | 3.077 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 1 -4.1934138 0 -2.7168513 0.72358299 + 10 1.0170498 -4.2225288 0 -2.7207912 0.7556766 + 20 0.92567967 -4.0920979 0 -2.725274 1.2463143 + 30 1.0851758 -4.3346599 0 -2.73233 0.53176652 + 40 1.2163699 -4.5351986 0 -2.7391524 -0.077915153 + 50 1.2305739 -4.5558134 0 -2.7387942 -0.10711153 + 60 1.1172288 -4.3979372 0 -2.7482791 0.52752067 + 70 1.2228415 -4.5540741 0 -2.7484722 0.11937533 + 80 1.1776333 -4.4870195 0 -2.7481704 0.33904864 + 90 1.219283 -4.5483185 0 -2.747971 0.17898549 + 100 1.2138939 -4.5432229 0 -2.7508327 0.3076354 +delete_atoms group all +Deleted 64 atoms, new total = 0 + 1 by 2 by 2 MPI processor grid +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Per MPI rank memory allocation (min/avg/max) = 3.077 | 3.077 | 3.077 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 1 -3.8524214 0 -2.3758589 4.6814052 + 10 1.3356745 -4.3481612 0 -2.3759544 3.061856 + 20 1.1791601 -4.117932 0 -2.3768284 3.8565 + 30 1.3435556 -4.3613609 0 -2.3775171 3.0728735 + 40 1.5628445 -4.6886004 0 -2.3809628 2.0989245 + 50 1.4735556 -4.5569123 0 -2.3811152 2.6364099 + 60 1.609387 -4.7581056 0 -2.3817452 1.8988642 + 70 1.5014902 -4.5938759 0 -2.3768318 2.458161 + 80 1.3763383 -4.4089865 0 -2.3767369 3.0379808 + 90 1.498202 -4.5909613 0 -2.3787724 2.5543714 + 100 1.43934 -4.5009545 0 -2.375679 3.0923444 + +Total wall time: 0:00:00 diff --git a/examples/mdi/log.17Jun22.series.alone.1 b/examples/mdi/log.17Jun22.series.alone.1 new file mode 100644 index 0000000000..3e44a5c950 --- /dev/null +++ b/examples/mdi/log.17Jun22.series.alone.1 @@ -0,0 +1,248 @@ +LAMMPS (2 Jun 2022) +# 3d Lennard-Jones melt - MDI driver script + +variable x index 5 +variable y index 5 +variable z index 5 + +variable rho index 0.7 0.8 0.9 + +label LOOP + + units lj + atom_style atomic + + read_data data.series.${rho} + read_data data.series.0.7 +Reading data file ... + orthogonal box = (0 0 0) to (8.9390354 8.9390354 8.9390354) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 500 atoms + reading velocities ... + 500 velocities + read_data CPU = 0.004 seconds + + displace_atoms all random 0.1 0.1 0.1 48294 +Displacing atoms ... + + pair_style lj/cut 2.5 + pair_coeff 1 1 1.0 1.0 2.5 + + neighbor 0.3 bin + neigh_modify delay 0 every 1 check yes + + compute 1 all pressure NULL virial + + thermo_style custom step temp pe c_1 c_1[1] c_1[2] c_1[3] + + run 0 +WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 2.8 + ghost atom cutoff = 2.8 + binsize = 1.4, bins = 7 7 7 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair lj/cut, perpetual + attributes: half, newton on + pair build: half/bin/atomonly/newton + stencil: half/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 3.137 | 3.137 | 3.137 Mbytes + Step Temp PotEng c_1 c_1[1] c_1[2] c_1[3] + 0 0 -5.200819 -4.5647906 -4.5444385 -4.5699966 -4.5799366 +Loop time of 2.729e-06 on 1 procs for 0 steps with 500 atoms + +109.9% CPU use with 1 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0 | 0 | 0 | 0.0 | 0.00 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0 | 0 | 0 | 0.0 | 0.00 +Output | 0 | 0 | 0 | 0.0 | 0.00 +Modify | 0 | 0 | 0 | 0.0 | 0.00 +Other | | 2.729e-06 | | |100.00 + +Nlocal: 500 ave 500 max 500 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 1956 ave 1956 max 1956 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 15687 ave 15687 max 15687 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 15687 +Ave neighs/atom = 31.374 +Neighbor list builds = 0 +Dangerous builds = 0 + + write_dump all custom dump.series.alone id type x y z fx fy fz modify sort id append yes + + clear + +next rho + +jump SELF LOOP + + units lj + atom_style atomic + + read_data data.series.${rho} + read_data data.series.0.8 +Reading data file ... + orthogonal box = (0 0 0) to (8.5498797 8.5498797 8.5498797) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 500 atoms + reading velocities ... + 500 velocities + read_data CPU = 0.004 seconds + + displace_atoms all random 0.1 0.1 0.1 48294 +Displacing atoms ... + + pair_style lj/cut 2.5 + pair_coeff 1 1 1.0 1.0 2.5 + + neighbor 0.3 bin + neigh_modify delay 0 every 1 check yes + + compute 1 all pressure NULL virial + + thermo_style custom step temp pe c_1 c_1[1] c_1[2] c_1[3] + + run 0 +WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 2.8 + ghost atom cutoff = 2.8 + binsize = 1.4, bins = 7 7 7 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair lj/cut, perpetual + attributes: half, newton on + pair build: half/bin/atomonly/newton + stencil: half/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 3.135 | 3.135 | 3.135 Mbytes + Step Temp PotEng c_1 c_1[1] c_1[2] c_1[3] + 0 0 -6.0419499 -4.2737827 -4.2865535 -4.2176976 -4.3170971 +Loop time of 1.434e-06 on 1 procs for 0 steps with 500 atoms + +139.5% CPU use with 1 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0 | 0 | 0 | 0.0 | 0.00 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0 | 0 | 0 | 0.0 | 0.00 +Output | 0 | 0 | 0 | 0.0 | 0.00 +Modify | 0 | 0 | 0 | 0.0 | 0.00 +Other | | 1.434e-06 | | |100.00 + +Nlocal: 500 ave 500 max 500 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 1956 ave 1956 max 1956 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 18734 ave 18734 max 18734 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 18734 +Ave neighs/atom = 37.468 +Neighbor list builds = 0 +Dangerous builds = 0 + + write_dump all custom dump.series.alone id type x y z fx fy fz modify sort id append yes + + clear + +next rho + +jump SELF LOOP + + units lj + atom_style atomic + + read_data data.series.${rho} + read_data data.series.0.9 +Reading data file ... + orthogonal box = (0 0 0) to (8.2207069 8.2207069 8.2207069) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 500 atoms + reading velocities ... + 500 velocities + read_data CPU = 0.003 seconds + + displace_atoms all random 0.1 0.1 0.1 48294 +Displacing atoms ... + + pair_style lj/cut 2.5 + pair_coeff 1 1 1.0 1.0 2.5 + + neighbor 0.3 bin + neigh_modify delay 0 every 1 check yes + + compute 1 all pressure NULL virial + + thermo_style custom step temp pe c_1 c_1[1] c_1[2] c_1[3] + + run 0 +WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 2.8 + ghost atom cutoff = 2.8 + binsize = 1.4, bins = 6 6 6 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair lj/cut, perpetual + attributes: half, newton on + pair build: half/bin/atomonly/newton + stencil: half/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 3.134 | 3.134 | 3.134 Mbytes + Step Temp PotEng c_1 c_1[1] c_1[2] c_1[3] + 0 0 -6.4477578 -1.5268553 -1.5717034 -1.568693 -1.4401696 +Loop time of 1.483e-06 on 1 procs for 0 steps with 500 atoms + +134.9% CPU use with 1 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0 | 0 | 0 | 0.0 | 0.00 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0 | 0 | 0 | 0.0 | 0.00 +Output | 0 | 0 | 0 | 0.0 | 0.00 +Modify | 0 | 0 | 0 | 0.0 | 0.00 +Other | | 1.483e-06 | | |100.00 + +Nlocal: 500 ave 500 max 500 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 1956 ave 1956 max 1956 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 20023 ave 20023 max 20023 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 20023 +Ave neighs/atom = 40.046 +Neighbor list builds = 0 +Dangerous builds = 0 + + write_dump all custom dump.series.alone id type x y z fx fy fz modify sort id append yes + + clear + +next rho + +jump SELF LOOP +Total wall time: 0:00:00 diff --git a/examples/mdi/log.17Jun22.series.driver.mpi.1 b/examples/mdi/log.17Jun22.series.driver.mpi.1 new file mode 100644 index 0000000000..4b109f8724 --- /dev/null +++ b/examples/mdi/log.17Jun22.series.driver.mpi.1 @@ -0,0 +1,213 @@ +LAMMPS (2 Jun 2022) +# 3d Lennard-Jones melt - MDI driver script + +variable x index 5 +variable y index 5 +variable z index 5 + +variable rho index 0.7 0.8 0.9 + +mdi connect + +label LOOP + + units lj + atom_style atomic + + read_data data.series.${rho} + read_data data.series.0.7 +Reading data file ... + orthogonal box = (0 0 0) to (8.9390354 8.9390354 8.9390354) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 500 atoms + reading velocities ... + 500 velocities + read_data CPU = 0.003 seconds + + displace_atoms all random 0.1 0.1 0.1 48294 +Displacing atoms ... + + neighbor 0.3 bin + neigh_modify delay 0 every 1 check yes + + fix 1 all mdi/qm add no virial yes connect no + variable evirial equal (f_1[1]+f_1[2]+f_1[3])/3 + + thermo_style custom step temp f_1 v_evirial f_1[1] f_1[2] f_1[3] + + run 0 +WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) +WARNING: No pairwise cutoff or binsize set. Atom sorting therefore disabled. (../atom.cpp:2127) +WARNING: Communication cutoff is 0.0. No ghost atoms will be generated. Atoms may get lost. (../comm_brick.cpp:210) +Per MPI rank memory allocation (min/avg/max) = 2.297 | 2.297 | 2.297 Mbytes + Step Temp f_1 v_evirial f_1[1] f_1[2] f_1[3] + 0 0 -5.200819 -4.5647906 -4.5444385 -4.5699966 -4.5799366 +Loop time of 1.919e-06 on 1 procs for 0 steps with 500 atoms + +0.0% CPU use with 1 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0 | 0 | 0 | 0.0 | 0.00 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0 | 0 | 0 | 0.0 | 0.00 +Output | 0 | 0 | 0 | 0.0 | 0.00 +Modify | 0 | 0 | 0 | 0.0 | 0.00 +Other | | 1.919e-06 | | |100.00 + +Nlocal: 500 ave 500 max 500 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 0 ave 0 max 0 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 0 ave 0 max 0 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 0 +Ave neighs/atom = 0 +Neighbor list builds = 0 +Dangerous builds = 0 + + write_dump all custom dump.series.driver id type x y z f_1[1] f_1[2] f_1[3] modify sort id append yes + + clear + +next rho + +jump SELF LOOP + + units lj + atom_style atomic + + read_data data.series.${rho} + read_data data.series.0.8 +Reading data file ... + orthogonal box = (0 0 0) to (8.5498797 8.5498797 8.5498797) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 500 atoms + reading velocities ... + 500 velocities + read_data CPU = 0.003 seconds + + displace_atoms all random 0.1 0.1 0.1 48294 +Displacing atoms ... + + neighbor 0.3 bin + neigh_modify delay 0 every 1 check yes + + fix 1 all mdi/qm add no virial yes connect no + variable evirial equal (f_1[1]+f_1[2]+f_1[3])/3 + + thermo_style custom step temp f_1 v_evirial f_1[1] f_1[2] f_1[3] + + run 0 +WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) +WARNING: No pairwise cutoff or binsize set. Atom sorting therefore disabled. (../atom.cpp:2127) +WARNING: Communication cutoff is 0.0. No ghost atoms will be generated. Atoms may get lost. (../comm_brick.cpp:210) +Per MPI rank memory allocation (min/avg/max) = 2.297 | 2.297 | 2.297 Mbytes + Step Temp f_1 v_evirial f_1[1] f_1[2] f_1[3] + 0 0 -6.0419499 -4.2737827 -4.2865535 -4.2176976 -4.3170971 +Loop time of 1.141e-06 on 1 procs for 0 steps with 500 atoms + +87.6% CPU use with 1 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0 | 0 | 0 | 0.0 | 0.00 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0 | 0 | 0 | 0.0 | 0.00 +Output | 0 | 0 | 0 | 0.0 | 0.00 +Modify | 0 | 0 | 0 | 0.0 | 0.00 +Other | | 1.141e-06 | | |100.00 + +Nlocal: 500 ave 500 max 500 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 0 ave 0 max 0 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 0 ave 0 max 0 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 0 +Ave neighs/atom = 0 +Neighbor list builds = 0 +Dangerous builds = 0 + + write_dump all custom dump.series.driver id type x y z f_1[1] f_1[2] f_1[3] modify sort id append yes + + clear + +next rho + +jump SELF LOOP + + units lj + atom_style atomic + + read_data data.series.${rho} + read_data data.series.0.9 +Reading data file ... + orthogonal box = (0 0 0) to (8.2207069 8.2207069 8.2207069) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 500 atoms + reading velocities ... + 500 velocities + read_data CPU = 0.002 seconds + + displace_atoms all random 0.1 0.1 0.1 48294 +Displacing atoms ... + + neighbor 0.3 bin + neigh_modify delay 0 every 1 check yes + + fix 1 all mdi/qm add no virial yes connect no + variable evirial equal (f_1[1]+f_1[2]+f_1[3])/3 + + thermo_style custom step temp f_1 v_evirial f_1[1] f_1[2] f_1[3] + + run 0 +WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) +WARNING: No pairwise cutoff or binsize set. Atom sorting therefore disabled. (../atom.cpp:2127) +WARNING: Communication cutoff is 0.0. No ghost atoms will be generated. Atoms may get lost. (../comm_brick.cpp:210) +Per MPI rank memory allocation (min/avg/max) = 2.297 | 2.297 | 2.297 Mbytes + Step Temp f_1 v_evirial f_1[1] f_1[2] f_1[3] + 0 0 -6.4477578 -1.5268553 -1.5717034 -1.568693 -1.4401696 +Loop time of 1.019e-06 on 1 procs for 0 steps with 500 atoms + +98.1% CPU use with 1 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0 | 0 | 0 | 0.0 | 0.00 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0 | 0 | 0 | 0.0 | 0.00 +Output | 0 | 0 | 0 | 0.0 | 0.00 +Modify | 0 | 0 | 0 | 0.0 | 0.00 +Other | | 1.019e-06 | | |100.00 + +Nlocal: 500 ave 500 max 500 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 0 ave 0 max 0 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 0 ave 0 max 0 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 0 +Ave neighs/atom = 0 +Neighbor list builds = 0 +Dangerous builds = 0 + + write_dump all custom dump.series.driver id type x y z f_1[1] f_1[2] f_1[3] modify sort id append yes + + clear + +next rho + +jump SELF LOOP + +mdi exit +Total wall time: 0:00:00 diff --git a/examples/mdi/log.17Jun22.series.driver.mpi.3 b/examples/mdi/log.17Jun22.series.driver.mpi.3 new file mode 100644 index 0000000000..9c042f4194 --- /dev/null +++ b/examples/mdi/log.17Jun22.series.driver.mpi.3 @@ -0,0 +1,213 @@ +LAMMPS (2 Jun 2022) +# 3d Lennard-Jones melt - MDI driver script + +variable x index 5 +variable y index 5 +variable z index 5 + +variable rho index 0.7 0.8 0.9 + +mdi connect + +label LOOP + + units lj + atom_style atomic + + read_data data.series.${rho} + read_data data.series.0.7 +Reading data file ... + orthogonal box = (0 0 0) to (8.9390354 8.9390354 8.9390354) + 1 by 1 by 3 MPI processor grid + reading atoms ... + 500 atoms + reading velocities ... + 500 velocities + read_data CPU = 0.004 seconds + + displace_atoms all random 0.1 0.1 0.1 48294 +Displacing atoms ... + + neighbor 0.3 bin + neigh_modify delay 0 every 1 check yes + + fix 1 all mdi/qm add no virial yes connect no + variable evirial equal (f_1[1]+f_1[2]+f_1[3])/3 + + thermo_style custom step temp f_1 v_evirial f_1[1] f_1[2] f_1[3] + + run 0 +WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) +WARNING: No pairwise cutoff or binsize set. Atom sorting therefore disabled. (../atom.cpp:2127) +WARNING: Communication cutoff is 0.0. No ghost atoms will be generated. Atoms may get lost. (../comm_brick.cpp:210) +Per MPI rank memory allocation (min/avg/max) = 2.297 | 2.297 | 2.297 Mbytes + Step Temp f_1 v_evirial f_1[1] f_1[2] f_1[3] + 0 0 -5.200819 -4.5647906 -4.5444385 -4.5699966 -4.5799366 +Loop time of 4.00933e-06 on 3 procs for 0 steps with 500 atoms + +91.5% CPU use with 3 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0 | 0 | 0 | 0.0 | 0.00 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0 | 0 | 0 | 0.0 | 0.00 +Output | 0 | 0 | 0 | 0.0 | 0.00 +Modify | 0 | 0 | 0 | 0.0 | 0.00 +Other | | 4.009e-06 | | |100.00 + +Nlocal: 166.667 ave 177 max 150 min +Histogram: 1 0 0 0 0 0 0 0 1 1 +Nghost: 0 ave 0 max 0 min +Histogram: 3 0 0 0 0 0 0 0 0 0 +Neighs: 0 ave 0 max 0 min +Histogram: 3 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 0 +Ave neighs/atom = 0 +Neighbor list builds = 0 +Dangerous builds = 0 + + write_dump all custom dump.series.driver id type x y z f_1[1] f_1[2] f_1[3] modify sort id append yes + + clear + +next rho + +jump SELF LOOP + + units lj + atom_style atomic + + read_data data.series.${rho} + read_data data.series.0.8 +Reading data file ... + orthogonal box = (0 0 0) to (8.5498797 8.5498797 8.5498797) + 1 by 1 by 3 MPI processor grid + reading atoms ... + 500 atoms + reading velocities ... + 500 velocities + read_data CPU = 0.003 seconds + + displace_atoms all random 0.1 0.1 0.1 48294 +Displacing atoms ... + + neighbor 0.3 bin + neigh_modify delay 0 every 1 check yes + + fix 1 all mdi/qm add no virial yes connect no + variable evirial equal (f_1[1]+f_1[2]+f_1[3])/3 + + thermo_style custom step temp f_1 v_evirial f_1[1] f_1[2] f_1[3] + + run 0 +WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) +WARNING: No pairwise cutoff or binsize set. Atom sorting therefore disabled. (../atom.cpp:2127) +WARNING: Communication cutoff is 0.0. No ghost atoms will be generated. Atoms may get lost. (../comm_brick.cpp:210) +Per MPI rank memory allocation (min/avg/max) = 2.297 | 2.297 | 2.297 Mbytes + Step Temp f_1 v_evirial f_1[1] f_1[2] f_1[3] + 0 0 -6.0419499 -4.2737827 -4.2865535 -4.2176976 -4.3170971 +Loop time of 3.11833e-06 on 3 procs for 0 steps with 500 atoms + +117.6% CPU use with 3 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0 | 0 | 0 | 0.0 | 0.00 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0 | 0 | 0 | 0.0 | 0.00 +Output | 0 | 0 | 0 | 0.0 | 0.00 +Modify | 0 | 0 | 0 | 0.0 | 0.00 +Other | | 3.118e-06 | | |100.00 + +Nlocal: 166.667 ave 178 max 150 min +Histogram: 1 0 0 0 0 0 0 1 0 1 +Nghost: 0 ave 0 max 0 min +Histogram: 3 0 0 0 0 0 0 0 0 0 +Neighs: 0 ave 0 max 0 min +Histogram: 3 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 0 +Ave neighs/atom = 0 +Neighbor list builds = 0 +Dangerous builds = 0 + + write_dump all custom dump.series.driver id type x y z f_1[1] f_1[2] f_1[3] modify sort id append yes + + clear + +next rho + +jump SELF LOOP + + units lj + atom_style atomic + + read_data data.series.${rho} + read_data data.series.0.9 +Reading data file ... + orthogonal box = (0 0 0) to (8.2207069 8.2207069 8.2207069) + 3 by 1 by 1 MPI processor grid + reading atoms ... + 500 atoms + reading velocities ... + 500 velocities + read_data CPU = 0.003 seconds + + displace_atoms all random 0.1 0.1 0.1 48294 +Displacing atoms ... + + neighbor 0.3 bin + neigh_modify delay 0 every 1 check yes + + fix 1 all mdi/qm add no virial yes connect no + variable evirial equal (f_1[1]+f_1[2]+f_1[3])/3 + + thermo_style custom step temp f_1 v_evirial f_1[1] f_1[2] f_1[3] + + run 0 +WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) +WARNING: No pairwise cutoff or binsize set. Atom sorting therefore disabled. (../atom.cpp:2127) +WARNING: Communication cutoff is 0.0. No ghost atoms will be generated. Atoms may get lost. (../comm_brick.cpp:210) +Per MPI rank memory allocation (min/avg/max) = 2.297 | 2.297 | 2.297 Mbytes + Step Temp f_1 v_evirial f_1[1] f_1[2] f_1[3] + 0 0 -6.4477578 -1.5268553 -1.5717034 -1.568693 -1.4401696 +Loop time of 2.85467e-06 on 3 procs for 0 steps with 500 atoms + +140.1% CPU use with 3 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0 | 0 | 0 | 0.0 | 0.00 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0 | 0 | 0 | 0.0 | 0.00 +Output | 0 | 0 | 0 | 0.0 | 0.00 +Modify | 0 | 0 | 0 | 0.0 | 0.00 +Other | | 2.855e-06 | | |100.00 + +Nlocal: 166.667 ave 181 max 150 min +Histogram: 1 0 0 0 0 0 1 0 0 1 +Nghost: 0 ave 0 max 0 min +Histogram: 3 0 0 0 0 0 0 0 0 0 +Neighs: 0 ave 0 max 0 min +Histogram: 3 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 0 +Ave neighs/atom = 0 +Neighbor list builds = 0 +Dangerous builds = 0 + + write_dump all custom dump.series.driver id type x y z f_1[1] f_1[2] f_1[3] modify sort id append yes + + clear + +next rho + +jump SELF LOOP + +mdi exit +Total wall time: 0:00:00 diff --git a/examples/mdi/log.17Jun22.series.driver.plugin.1 b/examples/mdi/log.17Jun22.series.driver.plugin.1 new file mode 100644 index 0000000000..13dd0f0f23 --- /dev/null +++ b/examples/mdi/log.17Jun22.series.driver.plugin.1 @@ -0,0 +1,212 @@ +LAMMPS (2 Jun 2022) +# 3d Lennard-Jones melt - MDI driver script + +variable x index 5 +variable y index 5 +variable z index 5 + +variable rho index 0.7 0.8 0.9 + +label LOOP + + units lj + atom_style atomic + + read_data data.series.${rho} + read_data data.series.0.7 +Reading data file ... + orthogonal box = (0 0 0) to (8.9390354 8.9390354 8.9390354) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 500 atoms + reading velocities ... + 500 velocities + read_data CPU = 0.004 seconds + + displace_atoms all random 0.1 0.1 0.1 48294 +Displacing atoms ... + + neighbor 0.3 bin + neigh_modify delay 0 every 1 check yes + + fix 1 all mdi/qm add no virial yes + variable evirial equal (f_1[1]+f_1[2]+f_1[3])/3 + + thermo_style custom step temp f_1 v_evirial f_1[1] f_1[2] f_1[3] + + mdi plugin lammps mdi "-role ENGINE -name LMP2 -method LINK" infile in.series.engine extra "-log log.series.engine.plugin" command "run 0" +run 0 +WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) +WARNING: No pairwise cutoff or binsize set. Atom sorting therefore disabled. (../atom.cpp:2127) +WARNING: Communication cutoff is 0.0. No ghost atoms will be generated. Atoms may get lost. (../comm_brick.cpp:210) +Per MPI rank memory allocation (min/avg/max) = 2.297 | 2.297 | 2.297 Mbytes + Step Temp f_1 v_evirial f_1[1] f_1[2] f_1[3] + 0 0 -5.200819 -4.5647906 -4.5444385 -4.5699966 -4.5799366 +Loop time of 2.359e-06 on 1 procs for 0 steps with 500 atoms + +127.2% CPU use with 1 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0 | 0 | 0 | 0.0 | 0.00 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0 | 0 | 0 | 0.0 | 0.00 +Output | 0 | 0 | 0 | 0.0 | 0.00 +Modify | 0 | 0 | 0 | 0.0 | 0.00 +Other | | 2.359e-06 | | |100.00 + +Nlocal: 500 ave 500 max 500 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 0 ave 0 max 0 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 0 ave 0 max 0 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 0 +Ave neighs/atom = 0 +Neighbor list builds = 0 +Dangerous builds = 0 + + write_dump all custom dump.series.driver.plugin id type x y z f_1[1] f_1[2] f_1[3] modify sort id append yes + + clear + +next rho + +jump SELF LOOP + + units lj + atom_style atomic + + read_data data.series.${rho} + read_data data.series.0.8 +Reading data file ... + orthogonal box = (0 0 0) to (8.5498797 8.5498797 8.5498797) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 500 atoms + reading velocities ... + 500 velocities + read_data CPU = 0.004 seconds + + displace_atoms all random 0.1 0.1 0.1 48294 +Displacing atoms ... + + neighbor 0.3 bin + neigh_modify delay 0 every 1 check yes + + fix 1 all mdi/qm add no virial yes + variable evirial equal (f_1[1]+f_1[2]+f_1[3])/3 + + thermo_style custom step temp f_1 v_evirial f_1[1] f_1[2] f_1[3] + + mdi plugin lammps mdi "-role ENGINE -name LMP2 -method LINK" infile in.series.engine extra "-log log.series.engine.plugin" command "run 0" +run 0 +WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) +WARNING: No pairwise cutoff or binsize set. Atom sorting therefore disabled. (../atom.cpp:2127) +WARNING: Communication cutoff is 0.0. No ghost atoms will be generated. Atoms may get lost. (../comm_brick.cpp:210) +Per MPI rank memory allocation (min/avg/max) = 2.297 | 2.297 | 2.297 Mbytes + Step Temp f_1 v_evirial f_1[1] f_1[2] f_1[3] + 0 0 -6.0419499 -4.2737827 -4.2865535 -4.2176976 -4.3170971 +Loop time of 1.468e-06 on 1 procs for 0 steps with 500 atoms + +204.4% CPU use with 1 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0 | 0 | 0 | 0.0 | 0.00 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0 | 0 | 0 | 0.0 | 0.00 +Output | 0 | 0 | 0 | 0.0 | 0.00 +Modify | 0 | 0 | 0 | 0.0 | 0.00 +Other | | 1.468e-06 | | |100.00 + +Nlocal: 500 ave 500 max 500 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 0 ave 0 max 0 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 0 ave 0 max 0 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 0 +Ave neighs/atom = 0 +Neighbor list builds = 0 +Dangerous builds = 0 + + write_dump all custom dump.series.driver.plugin id type x y z f_1[1] f_1[2] f_1[3] modify sort id append yes + + clear + +next rho + +jump SELF LOOP + + units lj + atom_style atomic + + read_data data.series.${rho} + read_data data.series.0.9 +Reading data file ... + orthogonal box = (0 0 0) to (8.2207069 8.2207069 8.2207069) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 500 atoms + reading velocities ... + 500 velocities + read_data CPU = 0.003 seconds + + displace_atoms all random 0.1 0.1 0.1 48294 +Displacing atoms ... + + neighbor 0.3 bin + neigh_modify delay 0 every 1 check yes + + fix 1 all mdi/qm add no virial yes + variable evirial equal (f_1[1]+f_1[2]+f_1[3])/3 + + thermo_style custom step temp f_1 v_evirial f_1[1] f_1[2] f_1[3] + + mdi plugin lammps mdi "-role ENGINE -name LMP2 -method LINK" infile in.series.engine extra "-log log.series.engine.plugin" command "run 0" +run 0 +WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) +WARNING: No pairwise cutoff or binsize set. Atom sorting therefore disabled. (../atom.cpp:2127) +WARNING: Communication cutoff is 0.0. No ghost atoms will be generated. Atoms may get lost. (../comm_brick.cpp:210) +Per MPI rank memory allocation (min/avg/max) = 2.297 | 2.297 | 2.297 Mbytes + Step Temp f_1 v_evirial f_1[1] f_1[2] f_1[3] + 0 0 -6.4477578 -1.5268553 -1.5717034 -1.568693 -1.4401696 +Loop time of 1.378e-06 on 1 procs for 0 steps with 500 atoms + +145.1% CPU use with 1 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0 | 0 | 0 | 0.0 | 0.00 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0 | 0 | 0 | 0.0 | 0.00 +Output | 0 | 0 | 0 | 0.0 | 0.00 +Modify | 0 | 0 | 0 | 0.0 | 0.00 +Other | | 1.378e-06 | | |100.00 + +Nlocal: 500 ave 500 max 500 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 0 ave 0 max 0 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 0 ave 0 max 0 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 0 +Ave neighs/atom = 0 +Neighbor list builds = 0 +Dangerous builds = 0 + + write_dump all custom dump.series.driver.plugin id type x y z f_1[1] f_1[2] f_1[3] modify sort id append yes + + clear + +next rho + +jump SELF LOOP +Total wall time: 0:00:00 diff --git a/examples/mdi/log.17Jun22.series.driver.plugin.3 b/examples/mdi/log.17Jun22.series.driver.plugin.3 new file mode 100644 index 0000000000..e32b35738f --- /dev/null +++ b/examples/mdi/log.17Jun22.series.driver.plugin.3 @@ -0,0 +1,212 @@ +LAMMPS (2 Jun 2022) +# 3d Lennard-Jones melt - MDI driver script + +variable x index 5 +variable y index 5 +variable z index 5 + +variable rho index 0.7 0.8 0.9 + +label LOOP + + units lj + atom_style atomic + + read_data data.series.${rho} + read_data data.series.0.7 +Reading data file ... + orthogonal box = (0 0 0) to (8.9390354 8.9390354 8.9390354) + 1 by 1 by 3 MPI processor grid + reading atoms ... + 500 atoms + reading velocities ... + 500 velocities + read_data CPU = 0.004 seconds + + displace_atoms all random 0.1 0.1 0.1 48294 +Displacing atoms ... + + neighbor 0.3 bin + neigh_modify delay 0 every 1 check yes + + fix 1 all mdi/qm add no virial yes + variable evirial equal (f_1[1]+f_1[2]+f_1[3])/3 + + thermo_style custom step temp f_1 v_evirial f_1[1] f_1[2] f_1[3] + + mdi plugin lammps mdi "-role ENGINE -name LMP2 -method LINK" infile in.series.engine extra "-log log.series.engine.plugin" command "run 0" +run 0 +WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) +WARNING: No pairwise cutoff or binsize set. Atom sorting therefore disabled. (../atom.cpp:2127) +WARNING: Communication cutoff is 0.0. No ghost atoms will be generated. Atoms may get lost. (../comm_brick.cpp:210) +Per MPI rank memory allocation (min/avg/max) = 2.297 | 2.297 | 2.297 Mbytes + Step Temp f_1 v_evirial f_1[1] f_1[2] f_1[3] + 0 0 -5.200819 -4.5647906 -4.5444385 -4.5699966 -4.5799366 +Loop time of 3.50867e-06 on 3 procs for 0 steps with 500 atoms + +114.0% CPU use with 3 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0 | 0 | 0 | 0.0 | 0.00 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0 | 0 | 0 | 0.0 | 0.00 +Output | 0 | 0 | 0 | 0.0 | 0.00 +Modify | 0 | 0 | 0 | 0.0 | 0.00 +Other | | 3.509e-06 | | |100.00 + +Nlocal: 166.667 ave 177 max 150 min +Histogram: 1 0 0 0 0 0 0 0 1 1 +Nghost: 0 ave 0 max 0 min +Histogram: 3 0 0 0 0 0 0 0 0 0 +Neighs: 0 ave 0 max 0 min +Histogram: 3 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 0 +Ave neighs/atom = 0 +Neighbor list builds = 0 +Dangerous builds = 0 + + write_dump all custom dump.series.driver.plugin id type x y z f_1[1] f_1[2] f_1[3] modify sort id append yes + + clear + +next rho + +jump SELF LOOP + + units lj + atom_style atomic + + read_data data.series.${rho} + read_data data.series.0.8 +Reading data file ... + orthogonal box = (0 0 0) to (8.5498797 8.5498797 8.5498797) + 1 by 1 by 3 MPI processor grid + reading atoms ... + 500 atoms + reading velocities ... + 500 velocities + read_data CPU = 0.003 seconds + + displace_atoms all random 0.1 0.1 0.1 48294 +Displacing atoms ... + + neighbor 0.3 bin + neigh_modify delay 0 every 1 check yes + + fix 1 all mdi/qm add no virial yes + variable evirial equal (f_1[1]+f_1[2]+f_1[3])/3 + + thermo_style custom step temp f_1 v_evirial f_1[1] f_1[2] f_1[3] + + mdi plugin lammps mdi "-role ENGINE -name LMP2 -method LINK" infile in.series.engine extra "-log log.series.engine.plugin" command "run 0" +run 0 +WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) +WARNING: No pairwise cutoff or binsize set. Atom sorting therefore disabled. (../atom.cpp:2127) +WARNING: Communication cutoff is 0.0. No ghost atoms will be generated. Atoms may get lost. (../comm_brick.cpp:210) +Per MPI rank memory allocation (min/avg/max) = 2.297 | 2.297 | 2.297 Mbytes + Step Temp f_1 v_evirial f_1[1] f_1[2] f_1[3] + 0 0 -6.0419499 -4.2737827 -4.2865535 -4.2176976 -4.3170971 +Loop time of 3.225e-06 on 3 procs for 0 steps with 500 atoms + +82.7% CPU use with 3 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0 | 0 | 0 | 0.0 | 0.00 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0 | 0 | 0 | 0.0 | 0.00 +Output | 0 | 0 | 0 | 0.0 | 0.00 +Modify | 0 | 0 | 0 | 0.0 | 0.00 +Other | | 3.225e-06 | | |100.00 + +Nlocal: 166.667 ave 178 max 150 min +Histogram: 1 0 0 0 0 0 0 1 0 1 +Nghost: 0 ave 0 max 0 min +Histogram: 3 0 0 0 0 0 0 0 0 0 +Neighs: 0 ave 0 max 0 min +Histogram: 3 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 0 +Ave neighs/atom = 0 +Neighbor list builds = 0 +Dangerous builds = 0 + + write_dump all custom dump.series.driver.plugin id type x y z f_1[1] f_1[2] f_1[3] modify sort id append yes + + clear + +next rho + +jump SELF LOOP + + units lj + atom_style atomic + + read_data data.series.${rho} + read_data data.series.0.9 +Reading data file ... + orthogonal box = (0 0 0) to (8.2207069 8.2207069 8.2207069) + 3 by 1 by 1 MPI processor grid + reading atoms ... + 500 atoms + reading velocities ... + 500 velocities + read_data CPU = 0.003 seconds + + displace_atoms all random 0.1 0.1 0.1 48294 +Displacing atoms ... + + neighbor 0.3 bin + neigh_modify delay 0 every 1 check yes + + fix 1 all mdi/qm add no virial yes + variable evirial equal (f_1[1]+f_1[2]+f_1[3])/3 + + thermo_style custom step temp f_1 v_evirial f_1[1] f_1[2] f_1[3] + + mdi plugin lammps mdi "-role ENGINE -name LMP2 -method LINK" infile in.series.engine extra "-log log.series.engine.plugin" command "run 0" +run 0 +WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) +WARNING: No pairwise cutoff or binsize set. Atom sorting therefore disabled. (../atom.cpp:2127) +WARNING: Communication cutoff is 0.0. No ghost atoms will be generated. Atoms may get lost. (../comm_brick.cpp:210) +Per MPI rank memory allocation (min/avg/max) = 2.297 | 2.297 | 2.297 Mbytes + Step Temp f_1 v_evirial f_1[1] f_1[2] f_1[3] + 0 0 -6.4477578 -1.5268553 -1.5717034 -1.568693 -1.4401696 +Loop time of 2.713e-06 on 3 procs for 0 steps with 500 atoms + +98.3% CPU use with 3 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0 | 0 | 0 | 0.0 | 0.00 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0 | 0 | 0 | 0.0 | 0.00 +Output | 0 | 0 | 0 | 0.0 | 0.00 +Modify | 0 | 0 | 0 | 0.0 | 0.00 +Other | | 2.713e-06 | | |100.00 + +Nlocal: 166.667 ave 181 max 150 min +Histogram: 1 0 0 0 0 0 1 0 0 1 +Nghost: 0 ave 0 max 0 min +Histogram: 3 0 0 0 0 0 0 0 0 0 +Neighs: 0 ave 0 max 0 min +Histogram: 3 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 0 +Ave neighs/atom = 0 +Neighbor list builds = 0 +Dangerous builds = 0 + + write_dump all custom dump.series.driver.plugin id type x y z f_1[1] f_1[2] f_1[3] modify sort id append yes + + clear + +next rho + +jump SELF LOOP +Total wall time: 0:00:00 diff --git a/examples/mdi/log.17Jun22.series.driver.tcp.1 b/examples/mdi/log.17Jun22.series.driver.tcp.1 new file mode 100644 index 0000000000..852f08a622 --- /dev/null +++ b/examples/mdi/log.17Jun22.series.driver.tcp.1 @@ -0,0 +1,213 @@ +LAMMPS (2 Jun 2022) +# 3d Lennard-Jones melt - MDI driver script + +variable x index 5 +variable y index 5 +variable z index 5 + +variable rho index 0.7 0.8 0.9 + +mdi connect + +label LOOP + + units lj + atom_style atomic + + read_data data.series.${rho} + read_data data.series.0.7 +Reading data file ... + orthogonal box = (0 0 0) to (8.9390354 8.9390354 8.9390354) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 500 atoms + reading velocities ... + 500 velocities + read_data CPU = 0.005 seconds + + displace_atoms all random 0.1 0.1 0.1 48294 +Displacing atoms ... + + neighbor 0.3 bin + neigh_modify delay 0 every 1 check yes + + fix 1 all mdi/qm add no virial yes connect no + variable evirial equal (f_1[1]+f_1[2]+f_1[3])/3 + + thermo_style custom step temp f_1 v_evirial f_1[1] f_1[2] f_1[3] + + run 0 +WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) +WARNING: No pairwise cutoff or binsize set. Atom sorting therefore disabled. (../atom.cpp:2127) +WARNING: Communication cutoff is 0.0. No ghost atoms will be generated. Atoms may get lost. (../comm_brick.cpp:210) +Per MPI rank memory allocation (min/avg/max) = 2.297 | 2.297 | 2.297 Mbytes + Step Temp f_1 v_evirial f_1[1] f_1[2] f_1[3] + 0 0 -5.200819 -4.5647906 -4.5444385 -4.5699966 -4.5799366 +Loop time of 3.017e-06 on 1 procs for 0 steps with 500 atoms + +99.4% CPU use with 1 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0 | 0 | 0 | 0.0 | 0.00 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0 | 0 | 0 | 0.0 | 0.00 +Output | 0 | 0 | 0 | 0.0 | 0.00 +Modify | 0 | 0 | 0 | 0.0 | 0.00 +Other | | 3.017e-06 | | |100.00 + +Nlocal: 500 ave 500 max 500 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 0 ave 0 max 0 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 0 ave 0 max 0 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 0 +Ave neighs/atom = 0 +Neighbor list builds = 0 +Dangerous builds = 0 + + write_dump all custom dump.series.driver id type x y z f_1[1] f_1[2] f_1[3] modify sort id append yes + + clear + +next rho + +jump SELF LOOP + + units lj + atom_style atomic + + read_data data.series.${rho} + read_data data.series.0.8 +Reading data file ... + orthogonal box = (0 0 0) to (8.5498797 8.5498797 8.5498797) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 500 atoms + reading velocities ... + 500 velocities + read_data CPU = 0.005 seconds + + displace_atoms all random 0.1 0.1 0.1 48294 +Displacing atoms ... + + neighbor 0.3 bin + neigh_modify delay 0 every 1 check yes + + fix 1 all mdi/qm add no virial yes connect no + variable evirial equal (f_1[1]+f_1[2]+f_1[3])/3 + + thermo_style custom step temp f_1 v_evirial f_1[1] f_1[2] f_1[3] + + run 0 +WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) +WARNING: No pairwise cutoff or binsize set. Atom sorting therefore disabled. (../atom.cpp:2127) +WARNING: Communication cutoff is 0.0. No ghost atoms will be generated. Atoms may get lost. (../comm_brick.cpp:210) +Per MPI rank memory allocation (min/avg/max) = 2.297 | 2.297 | 2.297 Mbytes + Step Temp f_1 v_evirial f_1[1] f_1[2] f_1[3] + 0 0 -6.0419499 -4.2737827 -4.2865535 -4.2176976 -4.3170971 +Loop time of 1.977e-06 on 1 procs for 0 steps with 500 atoms + +101.2% CPU use with 1 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0 | 0 | 0 | 0.0 | 0.00 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0 | 0 | 0 | 0.0 | 0.00 +Output | 0 | 0 | 0 | 0.0 | 0.00 +Modify | 0 | 0 | 0 | 0.0 | 0.00 +Other | | 1.977e-06 | | |100.00 + +Nlocal: 500 ave 500 max 500 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 0 ave 0 max 0 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 0 ave 0 max 0 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 0 +Ave neighs/atom = 0 +Neighbor list builds = 0 +Dangerous builds = 0 + + write_dump all custom dump.series.driver id type x y z f_1[1] f_1[2] f_1[3] modify sort id append yes + + clear + +next rho + +jump SELF LOOP + + units lj + atom_style atomic + + read_data data.series.${rho} + read_data data.series.0.9 +Reading data file ... + orthogonal box = (0 0 0) to (8.2207069 8.2207069 8.2207069) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 500 atoms + reading velocities ... + 500 velocities + read_data CPU = 0.004 seconds + + displace_atoms all random 0.1 0.1 0.1 48294 +Displacing atoms ... + + neighbor 0.3 bin + neigh_modify delay 0 every 1 check yes + + fix 1 all mdi/qm add no virial yes connect no + variable evirial equal (f_1[1]+f_1[2]+f_1[3])/3 + + thermo_style custom step temp f_1 v_evirial f_1[1] f_1[2] f_1[3] + + run 0 +WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) +WARNING: No pairwise cutoff or binsize set. Atom sorting therefore disabled. (../atom.cpp:2127) +WARNING: Communication cutoff is 0.0. No ghost atoms will be generated. Atoms may get lost. (../comm_brick.cpp:210) +Per MPI rank memory allocation (min/avg/max) = 2.297 | 2.297 | 2.297 Mbytes + Step Temp f_1 v_evirial f_1[1] f_1[2] f_1[3] + 0 0 -6.4477578 -1.5268553 -1.5717034 -1.568693 -1.4401696 +Loop time of 2.042e-06 on 1 procs for 0 steps with 500 atoms + +97.9% CPU use with 1 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0 | 0 | 0 | 0.0 | 0.00 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0 | 0 | 0 | 0.0 | 0.00 +Output | 0 | 0 | 0 | 0.0 | 0.00 +Modify | 0 | 0 | 0 | 0.0 | 0.00 +Other | | 2.042e-06 | | |100.00 + +Nlocal: 500 ave 500 max 500 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 0 ave 0 max 0 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 0 ave 0 max 0 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 0 +Ave neighs/atom = 0 +Neighbor list builds = 0 +Dangerous builds = 0 + + write_dump all custom dump.series.driver id type x y z f_1[1] f_1[2] f_1[3] modify sort id append yes + + clear + +next rho + +jump SELF LOOP + +mdi exit +Total wall time: 0:00:00 diff --git a/examples/mdi/log.17Jun22.series.driver.tcp.3 b/examples/mdi/log.17Jun22.series.driver.tcp.3 new file mode 100644 index 0000000000..5b2395c275 --- /dev/null +++ b/examples/mdi/log.17Jun22.series.driver.tcp.3 @@ -0,0 +1,213 @@ +LAMMPS (2 Jun 2022) +# 3d Lennard-Jones melt - MDI driver script + +variable x index 5 +variable y index 5 +variable z index 5 + +variable rho index 0.7 0.8 0.9 + +mdi connect + +label LOOP + + units lj + atom_style atomic + + read_data data.series.${rho} + read_data data.series.0.7 +Reading data file ... + orthogonal box = (0 0 0) to (8.9390354 8.9390354 8.9390354) + 1 by 1 by 3 MPI processor grid + reading atoms ... + 500 atoms + reading velocities ... + 500 velocities + read_data CPU = 0.005 seconds + + displace_atoms all random 0.1 0.1 0.1 48294 +Displacing atoms ... + + neighbor 0.3 bin + neigh_modify delay 0 every 1 check yes + + fix 1 all mdi/qm add no virial yes connect no + variable evirial equal (f_1[1]+f_1[2]+f_1[3])/3 + + thermo_style custom step temp f_1 v_evirial f_1[1] f_1[2] f_1[3] + + run 0 +WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) +WARNING: No pairwise cutoff or binsize set. Atom sorting therefore disabled. (../atom.cpp:2127) +WARNING: Communication cutoff is 0.0. No ghost atoms will be generated. Atoms may get lost. (../comm_brick.cpp:210) +Per MPI rank memory allocation (min/avg/max) = 2.297 | 2.297 | 2.297 Mbytes + Step Temp f_1 v_evirial f_1[1] f_1[2] f_1[3] + 0 0 -5.200819 -4.5647906 -4.5444385 -4.5699966 -4.5799366 +Loop time of 9.08933e-06 on 3 procs for 0 steps with 500 atoms + +95.3% CPU use with 3 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0 | 0 | 0 | 0.0 | 0.00 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0 | 0 | 0 | 0.0 | 0.00 +Output | 0 | 0 | 0 | 0.0 | 0.00 +Modify | 0 | 0 | 0 | 0.0 | 0.00 +Other | | 9.089e-06 | | |100.00 + +Nlocal: 166.667 ave 177 max 150 min +Histogram: 1 0 0 0 0 0 0 0 1 1 +Nghost: 0 ave 0 max 0 min +Histogram: 3 0 0 0 0 0 0 0 0 0 +Neighs: 0 ave 0 max 0 min +Histogram: 3 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 0 +Ave neighs/atom = 0 +Neighbor list builds = 0 +Dangerous builds = 0 + + write_dump all custom dump.series.driver id type x y z f_1[1] f_1[2] f_1[3] modify sort id append yes + + clear + +next rho + +jump SELF LOOP + + units lj + atom_style atomic + + read_data data.series.${rho} + read_data data.series.0.8 +Reading data file ... + orthogonal box = (0 0 0) to (8.5498797 8.5498797 8.5498797) + 1 by 1 by 3 MPI processor grid + reading atoms ... + 500 atoms + reading velocities ... + 500 velocities + read_data CPU = 0.005 seconds + + displace_atoms all random 0.1 0.1 0.1 48294 +Displacing atoms ... + + neighbor 0.3 bin + neigh_modify delay 0 every 1 check yes + + fix 1 all mdi/qm add no virial yes connect no + variable evirial equal (f_1[1]+f_1[2]+f_1[3])/3 + + thermo_style custom step temp f_1 v_evirial f_1[1] f_1[2] f_1[3] + + run 0 +WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) +WARNING: No pairwise cutoff or binsize set. Atom sorting therefore disabled. (../atom.cpp:2127) +WARNING: Communication cutoff is 0.0. No ghost atoms will be generated. Atoms may get lost. (../comm_brick.cpp:210) +Per MPI rank memory allocation (min/avg/max) = 2.297 | 2.297 | 2.297 Mbytes + Step Temp f_1 v_evirial f_1[1] f_1[2] f_1[3] + 0 0 -6.0419499 -4.2737827 -4.2865535 -4.2176976 -4.3170971 +Loop time of 3.63567e-06 on 3 procs for 0 steps with 500 atoms + +100.9% CPU use with 3 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0 | 0 | 0 | 0.0 | 0.00 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0 | 0 | 0 | 0.0 | 0.00 +Output | 0 | 0 | 0 | 0.0 | 0.00 +Modify | 0 | 0 | 0 | 0.0 | 0.00 +Other | | 3.636e-06 | | |100.00 + +Nlocal: 166.667 ave 178 max 150 min +Histogram: 1 0 0 0 0 0 0 1 0 1 +Nghost: 0 ave 0 max 0 min +Histogram: 3 0 0 0 0 0 0 0 0 0 +Neighs: 0 ave 0 max 0 min +Histogram: 3 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 0 +Ave neighs/atom = 0 +Neighbor list builds = 0 +Dangerous builds = 0 + + write_dump all custom dump.series.driver id type x y z f_1[1] f_1[2] f_1[3] modify sort id append yes + + clear + +next rho + +jump SELF LOOP + + units lj + atom_style atomic + + read_data data.series.${rho} + read_data data.series.0.9 +Reading data file ... + orthogonal box = (0 0 0) to (8.2207069 8.2207069 8.2207069) + 3 by 1 by 1 MPI processor grid + reading atoms ... + 500 atoms + reading velocities ... + 500 velocities + read_data CPU = 0.004 seconds + + displace_atoms all random 0.1 0.1 0.1 48294 +Displacing atoms ... + + neighbor 0.3 bin + neigh_modify delay 0 every 1 check yes + + fix 1 all mdi/qm add no virial yes connect no + variable evirial equal (f_1[1]+f_1[2]+f_1[3])/3 + + thermo_style custom step temp f_1 v_evirial f_1[1] f_1[2] f_1[3] + + run 0 +WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) +WARNING: No pairwise cutoff or binsize set. Atom sorting therefore disabled. (../atom.cpp:2127) +WARNING: Communication cutoff is 0.0. No ghost atoms will be generated. Atoms may get lost. (../comm_brick.cpp:210) +Per MPI rank memory allocation (min/avg/max) = 2.297 | 2.297 | 2.297 Mbytes + Step Temp f_1 v_evirial f_1[1] f_1[2] f_1[3] + 0 0 -6.4477578 -1.5268553 -1.5717034 -1.568693 -1.4401696 +Loop time of 3.806e-06 on 3 procs for 0 steps with 500 atoms + +105.1% CPU use with 3 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0 | 0 | 0 | 0.0 | 0.00 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0 | 0 | 0 | 0.0 | 0.00 +Output | 0 | 0 | 0 | 0.0 | 0.00 +Modify | 0 | 0 | 0 | 0.0 | 0.00 +Other | | 3.806e-06 | | |100.00 + +Nlocal: 166.667 ave 181 max 150 min +Histogram: 1 0 0 0 0 0 1 0 0 1 +Nghost: 0 ave 0 max 0 min +Histogram: 3 0 0 0 0 0 0 0 0 0 +Neighs: 0 ave 0 max 0 min +Histogram: 3 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 0 +Ave neighs/atom = 0 +Neighbor list builds = 0 +Dangerous builds = 0 + + write_dump all custom dump.series.driver id type x y z f_1[1] f_1[2] f_1[3] modify sort id append yes + + clear + +next rho + +jump SELF LOOP + +mdi exit +Total wall time: 0:00:00 diff --git a/examples/mdi/log.17Jun22.series.engine.mpi.1 b/examples/mdi/log.17Jun22.series.engine.mpi.1 new file mode 100644 index 0000000000..f644edc8d1 --- /dev/null +++ b/examples/mdi/log.17Jun22.series.engine.mpi.1 @@ -0,0 +1,58 @@ +LAMMPS (2 Jun 2022) +# 3d Lennard-Jones melt - MDI engine script + +units lj +atom_style atomic + +lattice fcc 1.0 +Lattice spacing in x,y,z = 1.5874011 1.5874011 1.5874011 +region box block 0 1 0 1 0 1 +create_box 1 box +Created orthogonal box = (0 0 0) to (1.5874011 1.5874011 1.5874011) + 1 by 1 by 1 MPI processor grid +mass 1 1.0 + +pair_style lj/cut 2.5 +pair_coeff 1 1 1.0 1.0 2.5 + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +mdi engine +delete_atoms group all +Deleted 0 atoms, new total = 0 + 1 by 1 by 1 MPI processor grid +WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 2.8 + ghost atom cutoff = 2.8 + binsize = 1.4, bins = 7 7 7 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair lj/cut, perpetual + attributes: half, newton on + pair build: half/bin/atomonly/newton + stencil: half/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 3.137 | 3.137 | 3.137 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 0 -5.200819 0 -5.200819 -4.5647906 +delete_atoms group all +Deleted 500 atoms, new total = 0 + 1 by 1 by 1 MPI processor grid +WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Per MPI rank memory allocation (min/avg/max) = 3.137 | 3.137 | 3.137 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 0 -6.0419499 0 -6.0419499 -4.2737827 +delete_atoms group all +Deleted 500 atoms, new total = 0 + 1 by 1 by 1 MPI processor grid +WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Per MPI rank memory allocation (min/avg/max) = 3.137 | 3.137 | 3.137 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 0 -6.4477578 0 -6.4477578 -1.5268553 +Total wall time: 0:00:00 diff --git a/examples/mdi/log.17Jun22.series.engine.mpi.4 b/examples/mdi/log.17Jun22.series.engine.mpi.4 new file mode 100644 index 0000000000..3561f4d232 --- /dev/null +++ b/examples/mdi/log.17Jun22.series.engine.mpi.4 @@ -0,0 +1,58 @@ +LAMMPS (2 Jun 2022) +# 3d Lennard-Jones melt - MDI engine script + +units lj +atom_style atomic + +lattice fcc 1.0 +Lattice spacing in x,y,z = 1.5874011 1.5874011 1.5874011 +region box block 0 1 0 1 0 1 +create_box 1 box +Created orthogonal box = (0 0 0) to (1.5874011 1.5874011 1.5874011) + 1 by 2 by 2 MPI processor grid +mass 1 1.0 + +pair_style lj/cut 2.5 +pair_coeff 1 1 1.0 1.0 2.5 + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +mdi engine +delete_atoms group all +Deleted 0 atoms, new total = 0 + 1 by 2 by 2 MPI processor grid +WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 2.8 + ghost atom cutoff = 2.8 + binsize = 1.4, bins = 7 7 7 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair lj/cut, perpetual + attributes: half, newton on + pair build: half/bin/atomonly/newton + stencil: half/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 3.103 | 3.103 | 3.103 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 0 -5.200819 0 -5.200819 -4.5647906 +delete_atoms group all +Deleted 500 atoms, new total = 0 + 1 by 2 by 2 MPI processor grid +WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Per MPI rank memory allocation (min/avg/max) = 3.103 | 3.103 | 3.103 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 0 -6.0419499 0 -6.0419499 -4.2737827 +delete_atoms group all +Deleted 500 atoms, new total = 0 + 1 by 2 by 2 MPI processor grid +WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Per MPI rank memory allocation (min/avg/max) = 3.103 | 3.103 | 3.103 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 0 -6.4477578 0 -6.4477578 -1.5268553 +Total wall time: 0:00:00 diff --git a/examples/mdi/log.17Jun22.series.engine.plugin.1 b/examples/mdi/log.17Jun22.series.engine.plugin.1 new file mode 100644 index 0000000000..322b40ad0e --- /dev/null +++ b/examples/mdi/log.17Jun22.series.engine.plugin.1 @@ -0,0 +1,42 @@ +LAMMPS (2 Jun 2022) +# 3d Lennard-Jones melt - MDI engine script + +units lj +atom_style atomic + +lattice fcc 1.0 +Lattice spacing in x,y,z = 1.5874011 1.5874011 1.5874011 +region box block 0 1 0 1 0 1 +create_box 1 box +Created orthogonal box = (0 0 0) to (1.5874011 1.5874011 1.5874011) + 1 by 1 by 1 MPI processor grid +mass 1 1.0 + +pair_style lj/cut 2.5 +pair_coeff 1 1 1.0 1.0 2.5 + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +mdi engine +delete_atoms group all +Deleted 0 atoms, new total = 0 + 1 by 1 by 1 MPI processor grid +WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 2.8 + ghost atom cutoff = 2.8 + binsize = 1.4, bins = 6 6 6 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair lj/cut, perpetual + attributes: half, newton on + pair build: half/bin/atomonly/newton + stencil: half/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 3.134 | 3.134 | 3.134 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 0 -6.4477578 0 -6.4477578 -1.5268553 +Total wall time: 0:00:00 diff --git a/examples/mdi/log.17Jun22.series.engine.plugin.3 b/examples/mdi/log.17Jun22.series.engine.plugin.3 new file mode 100644 index 0000000000..861a422e6b --- /dev/null +++ b/examples/mdi/log.17Jun22.series.engine.plugin.3 @@ -0,0 +1,42 @@ +LAMMPS (2 Jun 2022) +# 3d Lennard-Jones melt - MDI engine script + +units lj +atom_style atomic + +lattice fcc 1.0 +Lattice spacing in x,y,z = 1.5874011 1.5874011 1.5874011 +region box block 0 1 0 1 0 1 +create_box 1 box +Created orthogonal box = (0 0 0) to (1.5874011 1.5874011 1.5874011) + 1 by 1 by 3 MPI processor grid +mass 1 1.0 + +pair_style lj/cut 2.5 +pair_coeff 1 1 1.0 1.0 2.5 + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +mdi engine +delete_atoms group all +Deleted 0 atoms, new total = 0 + 3 by 1 by 1 MPI processor grid +WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 2.8 + ghost atom cutoff = 2.8 + binsize = 1.4, bins = 6 6 6 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair lj/cut, perpetual + attributes: half, newton on + pair build: half/bin/atomonly/newton + stencil: half/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 3.104 | 3.105 | 3.107 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 0 -6.4477578 0 -6.4477578 -1.5268553 +Total wall time: 0:00:00 diff --git a/examples/mdi/log.17Jun22.series.engine.tcp.1 b/examples/mdi/log.17Jun22.series.engine.tcp.1 new file mode 100644 index 0000000000..f644edc8d1 --- /dev/null +++ b/examples/mdi/log.17Jun22.series.engine.tcp.1 @@ -0,0 +1,58 @@ +LAMMPS (2 Jun 2022) +# 3d Lennard-Jones melt - MDI engine script + +units lj +atom_style atomic + +lattice fcc 1.0 +Lattice spacing in x,y,z = 1.5874011 1.5874011 1.5874011 +region box block 0 1 0 1 0 1 +create_box 1 box +Created orthogonal box = (0 0 0) to (1.5874011 1.5874011 1.5874011) + 1 by 1 by 1 MPI processor grid +mass 1 1.0 + +pair_style lj/cut 2.5 +pair_coeff 1 1 1.0 1.0 2.5 + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +mdi engine +delete_atoms group all +Deleted 0 atoms, new total = 0 + 1 by 1 by 1 MPI processor grid +WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 2.8 + ghost atom cutoff = 2.8 + binsize = 1.4, bins = 7 7 7 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair lj/cut, perpetual + attributes: half, newton on + pair build: half/bin/atomonly/newton + stencil: half/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 3.137 | 3.137 | 3.137 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 0 -5.200819 0 -5.200819 -4.5647906 +delete_atoms group all +Deleted 500 atoms, new total = 0 + 1 by 1 by 1 MPI processor grid +WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Per MPI rank memory allocation (min/avg/max) = 3.137 | 3.137 | 3.137 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 0 -6.0419499 0 -6.0419499 -4.2737827 +delete_atoms group all +Deleted 500 atoms, new total = 0 + 1 by 1 by 1 MPI processor grid +WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Per MPI rank memory allocation (min/avg/max) = 3.137 | 3.137 | 3.137 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 0 -6.4477578 0 -6.4477578 -1.5268553 +Total wall time: 0:00:00 diff --git a/examples/mdi/log.17Jun22.series.engine.tcp.4 b/examples/mdi/log.17Jun22.series.engine.tcp.4 new file mode 100644 index 0000000000..3561f4d232 --- /dev/null +++ b/examples/mdi/log.17Jun22.series.engine.tcp.4 @@ -0,0 +1,58 @@ +LAMMPS (2 Jun 2022) +# 3d Lennard-Jones melt - MDI engine script + +units lj +atom_style atomic + +lattice fcc 1.0 +Lattice spacing in x,y,z = 1.5874011 1.5874011 1.5874011 +region box block 0 1 0 1 0 1 +create_box 1 box +Created orthogonal box = (0 0 0) to (1.5874011 1.5874011 1.5874011) + 1 by 2 by 2 MPI processor grid +mass 1 1.0 + +pair_style lj/cut 2.5 +pair_coeff 1 1 1.0 1.0 2.5 + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +mdi engine +delete_atoms group all +Deleted 0 atoms, new total = 0 + 1 by 2 by 2 MPI processor grid +WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 2.8 + ghost atom cutoff = 2.8 + binsize = 1.4, bins = 7 7 7 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair lj/cut, perpetual + attributes: half, newton on + pair build: half/bin/atomonly/newton + stencil: half/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 3.103 | 3.103 | 3.103 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 0 -5.200819 0 -5.200819 -4.5647906 +delete_atoms group all +Deleted 500 atoms, new total = 0 + 1 by 2 by 2 MPI processor grid +WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Per MPI rank memory allocation (min/avg/max) = 3.103 | 3.103 | 3.103 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 0 -6.0419499 0 -6.0419499 -4.2737827 +delete_atoms group all +Deleted 500 atoms, new total = 0 + 1 by 2 by 2 MPI processor grid +WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Per MPI rank memory allocation (min/avg/max) = 3.103 | 3.103 | 3.103 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 0 -6.4477578 0 -6.4477578 -1.5268553 +Total wall time: 0:00:00 diff --git a/examples/mdi/log.17Jun22.snapshot.alone.1 b/examples/mdi/log.17Jun22.snapshot.alone.1 new file mode 100644 index 0000000000..44c39554f6 --- /dev/null +++ b/examples/mdi/log.17Jun22.snapshot.alone.1 @@ -0,0 +1,82 @@ +LAMMPS (2 Jun 2022) +# 3d Lennard-Jones melt - MDI driver script + +units lj +atom_style atomic + +read_data data.snapshot +Reading data file ... + orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 500 atoms + reading velocities ... + 500 velocities + read_data CPU = 0.005 seconds + +velocity all create 1.44 87287 loop geom + +pair_style lj/cut 2.5 +pair_coeff 1 1 1.0 1.0 2.5 + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +fix 1 all nve + +compute 1 all pressure NULL virial + +thermo_style custom step temp pe c_1 c_1[1] c_1[2] c_1[3] + +thermo 100 + +dump 1 all custom 100 dump.snapshot.alone id type x y z fx fy fz +dump_modify 1 sort id + +run 300 +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 2.8 + ghost atom cutoff = 2.8 + binsize = 1.4, bins = 6 6 6 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair lj/cut, perpetual + attributes: half, newton on + pair build: half/bin/atomonly/newton + stencil: half/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 4.461 | 4.461 | 4.461 Mbytes + Step Temp PotEng c_1 c_1[1] c_1[2] c_1[3] + 0 1.44 -6.7733681 -6.2353173 -6.2353173 -6.2353173 -6.2353173 + 100 0.75627629 -5.7579933 -0.4184022 -0.48020229 -0.33571704 -0.43928726 + 200 0.75199164 -5.752864 -0.40524506 -0.51524578 -0.27940441 -0.42108499 + 300 0.75219392 -5.7527975 -0.41843911 -0.24280603 -0.42189159 -0.59061972 +Loop time of 0.159268 on 1 procs for 300 steps with 500 atoms + +Performance: 813725.152 tau/day, 1883.623 timesteps/s +99.5% CPU use with 1 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.10659 | 0.10659 | 0.10659 | 0.0 | 66.93 +Neigh | 0.038637 | 0.038637 | 0.038637 | 0.0 | 24.26 +Comm | 0.0053144 | 0.0053144 | 0.0053144 | 0.0 | 3.34 +Output | 0.0048583 | 0.0048583 | 0.0048583 | 0.0 | 3.05 +Modify | 0.002043 | 0.002043 | 0.002043 | 0.0 | 1.28 +Other | | 0.001821 | | | 1.14 + +Nlocal: 500 ave 500 max 500 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 1898 ave 1898 max 1898 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 18744 ave 18744 max 18744 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 18744 +Ave neighs/atom = 37.488 +Neighbor list builds = 31 +Dangerous builds = 0 +Total wall time: 0:00:00 diff --git a/examples/mdi/log.17Jun22.snapshot.driver.mpi.1 b/examples/mdi/log.17Jun22.snapshot.driver.mpi.1 new file mode 100644 index 0000000000..cf15f32e9b --- /dev/null +++ b/examples/mdi/log.17Jun22.snapshot.driver.mpi.1 @@ -0,0 +1,105 @@ +LAMMPS (2 Jun 2022) +# 3d Lennard-Jones melt - MDI driver script + +units lj +atom_style atomic + +read_data data.snapshot +Reading data file ... + orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 500 atoms + reading velocities ... + 500 velocities + read_data CPU = 0.003 seconds + +velocity all create 1.44 87287 loop geom + +pair_style lj/cut 2.5 +pair_coeff 1 1 1.0 1.0 2.5 + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +fix 1 all nve + +fix 2 all mdi/qm add no every 100 virial yes + +compute 1 all pressure NULL virial +variable evirial equal (f_2[1]+f_2[2]+f_2[3])/3 + +thermo_style custom step temp pe c_1 c_1[1] c_1[2] c_1[3] + +thermo 100 + +dump 1 all custom 100 dump.snapshot.driver id type x y z f_2[1] f_2[2] f_2[3] +dump_modify 1 sort id + +run 300 pre no post no every 100 "print 'QM eng = $(f_2/atoms)'" "print 'QM virial = $(v_evirial) $(f_2[1]) $(f_2[2]) $(f_2[3])'" +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 2.8 + ghost atom cutoff = 2.8 + binsize = 1.4, bins = 6 6 6 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair lj/cut, perpetual + attributes: half, newton on + pair build: half/bin/atomonly/newton + stencil: half/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 4.461 | 4.461 | 4.461 Mbytes + Step Temp PotEng c_1 c_1[1] c_1[2] c_1[3] + 0 1.44 -6.7733681 -6.2353173 -6.2353173 -6.2353173 -6.2353173 + 100 0.75627629 -5.7579933 -0.4184022 -0.48020229 -0.33571704 -0.43928726 +Loop time of 0.052449 on 1 procs for 100 steps with 500 atoms + +print 'QM eng = $(f_2/atoms)' +QM eng = -5.7579933325734575789 +print 'QM virial = $(v_evirial) $(f_2[1]) $(f_2[2]) $(f_2[3])' +QM virial = -0.41840219542566597921 -0.48020228608206266818 -0.33571704057969975477 -0.43928725961523629184 + Step Temp PotEng c_1 c_1[1] c_1[2] c_1[3] + 100 0.75627629 -5.7579933 -0.4184022 -0.48020229 -0.33571704 -0.43928726 + 200 0.75199164 -5.752864 -0.40524506 -0.51524578 -0.27940441 -0.42108499 +Loop time of 0.0497171 on 1 procs for 100 steps with 500 atoms + +print 'QM eng = $(f_2/atoms)' +QM eng = -5.7528640103266583949 +print 'QM virial = $(v_evirial) $(f_2[1]) $(f_2[2]) $(f_2[3])' +QM virial = -0.40524505957306500292 -0.515245777483180456 -0.27940441114041408843 -0.42108499009560135251 + Step Temp PotEng c_1 c_1[1] c_1[2] c_1[3] + 200 0.75199164 -5.752864 -0.40524506 -0.51524578 -0.27940441 -0.42108499 + 300 0.75219392 -5.7527975 -0.41843911 -0.24280603 -0.42189159 -0.59061972 +Loop time of 0.0506296 on 1 procs for 100 steps with 500 atoms + +Performance: 853255.432 tau/day, 1975.128 timesteps/s +100.0% CPU use with 1 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.032111 | 0.032111 | 0.032111 | 0.0 | 63.42 +Neigh | 0.012403 | 0.012403 | 0.012403 | 0.0 | 24.50 +Comm | 0.0016352 | 0.0016352 | 0.0016352 | 0.0 | 3.23 +Output | 0.001556 | 0.001556 | 0.001556 | 0.0 | 3.07 +Modify | 0.0023767 | 0.0023767 | 0.0023767 | 0.0 | 4.69 +Other | | 0.0005478 | | | 1.08 + +Nlocal: 500 ave 500 max 500 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 1898 ave 1898 max 1898 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 18744 ave 18744 max 18744 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 18744 +Ave neighs/atom = 37.488 +Neighbor list builds = 31 +Dangerous builds = 0 +print 'QM eng = $(f_2/atoms)' +QM eng = -5.7527974697327088904 +print 'QM virial = $(v_evirial) $(f_2[1]) $(f_2[2]) $(f_2[3])' +QM virial = -0.41843911315518900196 -0.24280603320322050043 -0.4218915869116203754 -0.59061971935072643536 +Total wall time: 0:00:00 diff --git a/examples/mdi/log.17Jun22.snapshot.driver.mpi.3 b/examples/mdi/log.17Jun22.snapshot.driver.mpi.3 new file mode 100644 index 0000000000..8382b128e1 --- /dev/null +++ b/examples/mdi/log.17Jun22.snapshot.driver.mpi.3 @@ -0,0 +1,105 @@ +LAMMPS (2 Jun 2022) +# 3d Lennard-Jones melt - MDI driver script + +units lj +atom_style atomic + +read_data data.snapshot +Reading data file ... + orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) + 1 by 1 by 3 MPI processor grid + reading atoms ... + 500 atoms + reading velocities ... + 500 velocities + read_data CPU = 0.004 seconds + +velocity all create 1.44 87287 loop geom + +pair_style lj/cut 2.5 +pair_coeff 1 1 1.0 1.0 2.5 + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +fix 1 all nve + +fix 2 all mdi/qm add no every 100 virial yes + +compute 1 all pressure NULL virial +variable evirial equal (f_2[1]+f_2[2]+f_2[3])/3 + +thermo_style custom step temp pe c_1 c_1[1] c_1[2] c_1[3] + +thermo 100 + +dump 1 all custom 100 dump.snapshot.driver id type x y z f_2[1] f_2[2] f_2[3] +dump_modify 1 sort id + +run 300 pre no post no every 100 "print 'QM eng = $(f_2/atoms)'" "print 'QM virial = $(v_evirial) $(f_2[1]) $(f_2[2]) $(f_2[3])'" +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 2.8 + ghost atom cutoff = 2.8 + binsize = 1.4, bins = 6 6 6 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair lj/cut, perpetual + attributes: half, newton on + pair build: half/bin/atomonly/newton + stencil: half/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 4.417 | 4.422 | 4.425 Mbytes + Step Temp PotEng c_1 c_1[1] c_1[2] c_1[3] + 0 1.44 -6.7733681 -6.2353173 -6.2353173 -6.2353173 -6.2353173 + 100 0.75627629 -5.7579933 -0.4184022 -0.48020229 -0.33571704 -0.43928726 +Loop time of 0.0242313 on 3 procs for 100 steps with 500 atoms + +print 'QM eng = $(f_2/atoms)' +QM eng = -5.7579933325734558025 +print 'QM virial = $(v_evirial) $(f_2[1]) $(f_2[2]) $(f_2[3])' +QM virial = -0.41840219542566797761 -0.4802022860820577832 -0.33571704057970208623 -0.43928725961524273114 + Step Temp PotEng c_1 c_1[1] c_1[2] c_1[3] + 100 0.75627629 -5.7579933 -0.4184022 -0.48020229 -0.33571704 -0.43928726 + 200 0.75199164 -5.752864 -0.40524506 -0.51524578 -0.27940441 -0.42108499 +Loop time of 0.0269411 on 3 procs for 100 steps with 500 atoms + +print 'QM eng = $(f_2/atoms)' +QM eng = -5.752864010326673494 +print 'QM virial = $(v_evirial) $(f_2[1]) $(f_2[2]) $(f_2[3])' +QM virial = -0.40524505957305401171 -0.51524577748319133619 -0.27940441114042008364 -0.4210849900955495051 + Step Temp PotEng c_1 c_1[1] c_1[2] c_1[3] + 200 0.75199164 -5.752864 -0.40524506 -0.51524578 -0.27940441 -0.42108499 + 300 0.75219392 -5.7527975 -0.41843911 -0.24280603 -0.42189159 -0.59061972 +Loop time of 0.022648 on 3 procs for 100 steps with 500 atoms + +Performance: 1907449.463 tau/day, 4415.392 timesteps/s +100.0% CPU use with 3 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.0091419 | 0.010422 | 0.011089 | 0.9 | 46.02 +Neigh | 0.0036491 | 0.0040749 | 0.0043554 | 0.5 | 17.99 +Comm | 0.004713 | 0.0056035 | 0.0073471 | 1.6 | 24.74 +Output | 0.00062782 | 0.00063348 | 0.00064461 | 0.0 | 2.80 +Modify | 0.0013385 | 0.0013655 | 0.0013943 | 0.1 | 6.03 +Other | | 0.0005485 | | | 2.42 + +Nlocal: 166.667 ave 175 max 157 min +Histogram: 1 0 0 0 0 0 1 0 0 1 +Nghost: 1254.33 ave 1264 max 1246 min +Histogram: 1 0 0 1 0 0 0 0 0 1 +Neighs: 6248 ave 6632 max 5774 min +Histogram: 1 0 0 0 0 0 1 0 0 1 + +Total # of neighbors = 18744 +Ave neighs/atom = 37.488 +Neighbor list builds = 31 +Dangerous builds = 0 +print 'QM eng = $(f_2/atoms)' +QM eng = -5.752797469732716884 +print 'QM virial = $(v_evirial) $(f_2[1]) $(f_2[2]) $(f_2[3])' +QM virial = -0.41843911315521897798 -0.24280603320323970729 -0.42189158691169792448 -0.590619719350719663 +Total wall time: 0:00:00 diff --git a/examples/mdi/log.17Jun22.snapshot.driver.plugin.1 b/examples/mdi/log.17Jun22.snapshot.driver.plugin.1 new file mode 100644 index 0000000000..4d140820c8 --- /dev/null +++ b/examples/mdi/log.17Jun22.snapshot.driver.plugin.1 @@ -0,0 +1,118 @@ +LAMMPS (2 Jun 2022) +# 3d Lennard-Jones melt - MDI driver script + +variable x index 5 +variable y index 5 +variable z index 5 + +units lj +atom_style atomic + +read_data data.snapshot +Reading data file ... + orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 500 atoms + reading velocities ... + 500 velocities + read_data CPU = 0.005 seconds + +velocity all create 1.44 87287 loop geom + +pair_style lj/cut 2.5 +pair_coeff 1 1 1.0 1.0 2.5 + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +fix 1 all nve + +fix 2 all mdi/qm add no every 100 virial yes + +compute 1 all pressure NULL virial +variable evirial equal (f_2[1]+f_2[2]+f_2[3])/3 + +thermo_style custom step temp pe c_1 c_1[1] c_1[2] c_1[3] + +thermo 100 + +dump 1 all custom 100 dump.snapshot.driver.plugin id type x y z f_2[1] f_2[2] f_2[3] +dump_modify 1 sort id + +mdi plugin lammps mdi "-role ENGINE -name LMP2 -method LINK" infile in.snapshot.engine extra "-log log.snapshot.engine.plugin" command """ + run 300 pre no post no every 100 + "print 'QM eng = $(f_2/atoms)'" + "print 'QM virial = $(v_evirial) $(f_2[1]) $(f_2[2]) $(f_2[3])'" + """ + + run 300 pre no post no every 100 + "print 'QM eng = $(f_2/atoms)'" + "print 'QM virial = $(v_evirial) $(f_2[1]) $(f_2[2]) $(f_2[3])'" + +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 2.8 + ghost atom cutoff = 2.8 + binsize = 1.4, bins = 6 6 6 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair lj/cut, perpetual + attributes: half, newton on + pair build: half/bin/atomonly/newton + stencil: half/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 4.461 | 4.461 | 4.461 Mbytes + Step Temp PotEng c_1 c_1[1] c_1[2] c_1[3] + 0 1.44 -6.7733681 -6.2353173 -6.2353173 -6.2353173 -6.2353173 + 100 0.75627629 -5.7579933 -0.4184022 -0.48020229 -0.33571704 -0.43928726 +Loop time of 0.0623265 on 1 procs for 100 steps with 500 atoms + +print 'QM eng = $(f_2/atoms)' +QM eng = -5.7579933325734575789 +print 'QM virial = $(v_evirial) $(f_2[1]) $(f_2[2]) $(f_2[3])' +QM virial = -0.41840219542566597921 -0.48020228608206266818 -0.33571704057969975477 -0.43928725961523629184 + Step Temp PotEng c_1 c_1[1] c_1[2] c_1[3] + 100 0.75627629 -5.7579933 -0.4184022 -0.48020229 -0.33571704 -0.43928726 + 200 0.75199164 -5.752864 -0.40524506 -0.51524578 -0.27940441 -0.42108499 +Loop time of 0.0498825 on 1 procs for 100 steps with 500 atoms + +print 'QM eng = $(f_2/atoms)' +QM eng = -5.7528640103266583949 +print 'QM virial = $(v_evirial) $(f_2[1]) $(f_2[2]) $(f_2[3])' +QM virial = -0.40524505957306500292 -0.515245777483180456 -0.27940441114041408843 -0.42108499009560135251 + Step Temp PotEng c_1 c_1[1] c_1[2] c_1[3] + 200 0.75199164 -5.752864 -0.40524506 -0.51524578 -0.27940441 -0.42108499 + 300 0.75219392 -5.7527975 -0.41843911 -0.24280603 -0.42189159 -0.59061972 +Loop time of 0.050109 on 1 procs for 100 steps with 500 atoms + +Performance: 862120.560 tau/day, 1995.649 timesteps/s +99.9% CPU use with 1 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.031747 | 0.031747 | 0.031747 | 0.0 | 63.36 +Neigh | 0.012304 | 0.012304 | 0.012304 | 0.0 | 24.55 +Comm | 0.0016113 | 0.0016113 | 0.0016113 | 0.0 | 3.22 +Output | 0.0015529 | 0.0015529 | 0.0015529 | 0.0 | 3.10 +Modify | 0.0023537 | 0.0023537 | 0.0023537 | 0.0 | 4.70 +Other | | 0.0005398 | | | 1.08 + +Nlocal: 500 ave 500 max 500 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 1898 ave 1898 max 1898 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 18744 ave 18744 max 18744 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 18744 +Ave neighs/atom = 37.488 +Neighbor list builds = 31 +Dangerous builds = 0 +print 'QM eng = $(f_2/atoms)' +QM eng = -5.7527974697327088904 +print 'QM virial = $(v_evirial) $(f_2[1]) $(f_2[2]) $(f_2[3])' +QM virial = -0.41843911315518900196 -0.24280603320322050043 -0.4218915869116203754 -0.59061971935072643536 +Total wall time: 0:00:00 diff --git a/examples/mdi/log.17Jun22.snapshot.driver.plugin.3 b/examples/mdi/log.17Jun22.snapshot.driver.plugin.3 new file mode 100644 index 0000000000..bb39f53598 --- /dev/null +++ b/examples/mdi/log.17Jun22.snapshot.driver.plugin.3 @@ -0,0 +1,118 @@ +LAMMPS (2 Jun 2022) +# 3d Lennard-Jones melt - MDI driver script + +variable x index 5 +variable y index 5 +variable z index 5 + +units lj +atom_style atomic + +read_data data.snapshot +Reading data file ... + orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) + 1 by 1 by 3 MPI processor grid + reading atoms ... + 500 atoms + reading velocities ... + 500 velocities + read_data CPU = 0.004 seconds + +velocity all create 1.44 87287 loop geom + +pair_style lj/cut 2.5 +pair_coeff 1 1 1.0 1.0 2.5 + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +fix 1 all nve + +fix 2 all mdi/qm add no every 100 virial yes + +compute 1 all pressure NULL virial +variable evirial equal (f_2[1]+f_2[2]+f_2[3])/3 + +thermo_style custom step temp pe c_1 c_1[1] c_1[2] c_1[3] + +thermo 100 + +dump 1 all custom 100 dump.snapshot.driver.plugin id type x y z f_2[1] f_2[2] f_2[3] +dump_modify 1 sort id + +mdi plugin lammps mdi "-role ENGINE -name LMP2 -method LINK" infile in.snapshot.engine extra "-log log.snapshot.engine.plugin" command """ + run 300 pre no post no every 100 + "print 'QM eng = $(f_2/atoms)'" + "print 'QM virial = $(v_evirial) $(f_2[1]) $(f_2[2]) $(f_2[3])'" + """ + + run 300 pre no post no every 100 + "print 'QM eng = $(f_2/atoms)'" + "print 'QM virial = $(v_evirial) $(f_2[1]) $(f_2[2]) $(f_2[3])'" + +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 2.8 + ghost atom cutoff = 2.8 + binsize = 1.4, bins = 6 6 6 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair lj/cut, perpetual + attributes: half, newton on + pair build: half/bin/atomonly/newton + stencil: half/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 4.417 | 4.422 | 4.425 Mbytes + Step Temp PotEng c_1 c_1[1] c_1[2] c_1[3] + 0 1.44 -6.7733681 -6.2353173 -6.2353173 -6.2353173 -6.2353173 + 100 0.75627629 -5.7579933 -0.4184022 -0.48020229 -0.33571704 -0.43928726 +Loop time of 0.0245664 on 3 procs for 100 steps with 500 atoms + +print 'QM eng = $(f_2/atoms)' +QM eng = -5.7579933325734442562 +print 'QM virial = $(v_evirial) $(f_2[1]) $(f_2[2]) $(f_2[3])' +QM virial = -0.41840219542566498001 -0.48020228608205661747 -0.33571704057970125357 -0.43928725961523629184 + Step Temp PotEng c_1 c_1[1] c_1[2] c_1[3] + 100 0.75627629 -5.7579933 -0.4184022 -0.48020229 -0.33571704 -0.43928726 + 200 0.75199164 -5.752864 -0.40524506 -0.51524578 -0.27940441 -0.42108499 +Loop time of 0.0221302 on 3 procs for 100 steps with 500 atoms + +print 'QM eng = $(f_2/atoms)' +QM eng = -5.7528640103266690531 +print 'QM virial = $(v_evirial) $(f_2[1]) $(f_2[2]) $(f_2[3])' +QM virial = -0.40524505957305301251 -0.51524577748319111414 -0.27940441114042025017 -0.42108499009554783976 + Step Temp PotEng c_1 c_1[1] c_1[2] c_1[3] + 200 0.75199164 -5.752864 -0.40524506 -0.51524578 -0.27940441 -0.42108499 + 300 0.75219392 -5.7527975 -0.41843911 -0.24280603 -0.42189159 -0.59061972 +Loop time of 0.0224519 on 3 procs for 100 steps with 500 atoms + +Performance: 1924114.069 tau/day, 4453.968 timesteps/s +100.0% CPU use with 3 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.0096043 | 0.010493 | 0.011044 | 0.6 | 46.74 +Neigh | 0.0037658 | 0.0041299 | 0.004422 | 0.4 | 18.39 +Comm | 0.0048946 | 0.0055617 | 0.0068824 | 1.3 | 24.77 +Output | 0.00063471 | 0.00063884 | 0.00064691 | 0.0 | 2.85 +Modify | 0.0010632 | 0.0010754 | 0.0010895 | 0.0 | 4.79 +Other | | 0.0005531 | | | 2.46 + +Nlocal: 166.667 ave 175 max 157 min +Histogram: 1 0 0 0 0 0 1 0 0 1 +Nghost: 1254.33 ave 1264 max 1246 min +Histogram: 1 0 0 1 0 0 0 0 0 1 +Neighs: 6248 ave 6632 max 5774 min +Histogram: 1 0 0 0 0 0 1 0 0 1 + +Total # of neighbors = 18744 +Ave neighs/atom = 37.488 +Neighbor list builds = 31 +Dangerous builds = 0 +print 'QM eng = $(f_2/atoms)' +QM eng = -5.7527974697327239895 +print 'QM virial = $(v_evirial) $(f_2[1]) $(f_2[2]) $(f_2[3])' +QM virial = -0.41843911315521697958 -0.24280603320323956851 -0.42189158691169470483 -0.59061971935071611028 +Total wall time: 0:00:00 diff --git a/examples/mdi/log.17Jun22.snapshot.driver.tcp.1 b/examples/mdi/log.17Jun22.snapshot.driver.tcp.1 new file mode 100644 index 0000000000..905e53e8e4 --- /dev/null +++ b/examples/mdi/log.17Jun22.snapshot.driver.tcp.1 @@ -0,0 +1,105 @@ +LAMMPS (2 Jun 2022) +# 3d Lennard-Jones melt - MDI driver script + +units lj +atom_style atomic + +read_data data.snapshot +Reading data file ... + orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 500 atoms + reading velocities ... + 500 velocities + read_data CPU = 0.004 seconds + +velocity all create 1.44 87287 loop geom + +pair_style lj/cut 2.5 +pair_coeff 1 1 1.0 1.0 2.5 + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +fix 1 all nve + +fix 2 all mdi/qm add no every 100 virial yes + +compute 1 all pressure NULL virial +variable evirial equal (f_2[1]+f_2[2]+f_2[3])/3 + +thermo_style custom step temp pe c_1 c_1[1] c_1[2] c_1[3] + +thermo 100 + +dump 1 all custom 100 dump.snapshot.driver id type x y z f_2[1] f_2[2] f_2[3] +dump_modify 1 sort id + +run 300 pre no post no every 100 "print 'QM eng = $(f_2/atoms)'" "print 'QM virial = $(v_evirial) $(f_2[1]) $(f_2[2]) $(f_2[3])'" +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 2.8 + ghost atom cutoff = 2.8 + binsize = 1.4, bins = 6 6 6 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair lj/cut, perpetual + attributes: half, newton on + pair build: half/bin/atomonly/newton + stencil: half/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 4.461 | 4.461 | 4.461 Mbytes + Step Temp PotEng c_1 c_1[1] c_1[2] c_1[3] + 0 1.44 -6.7733681 -6.2353173 -6.2353173 -6.2353173 -6.2353173 + 100 0.75627629 -5.7579933 -0.4184022 -0.48020229 -0.33571704 -0.43928726 +Loop time of 0.276735 on 1 procs for 100 steps with 500 atoms + +print 'QM eng = $(f_2/atoms)' +QM eng = -5.7579933325734575789 +print 'QM virial = $(v_evirial) $(f_2[1]) $(f_2[2]) $(f_2[3])' +QM virial = -0.41840219542566597921 -0.48020228608206266818 -0.33571704057969975477 -0.43928725961523629184 + Step Temp PotEng c_1 c_1[1] c_1[2] c_1[3] + 100 0.75627629 -5.7579933 -0.4184022 -0.48020229 -0.33571704 -0.43928726 + 200 0.75199164 -5.752864 -0.40524506 -0.51524578 -0.27940441 -0.42108499 +Loop time of 0.276667 on 1 procs for 100 steps with 500 atoms + +print 'QM eng = $(f_2/atoms)' +QM eng = -5.7528640103266583949 +print 'QM virial = $(v_evirial) $(f_2[1]) $(f_2[2]) $(f_2[3])' +QM virial = -0.40524505957306500292 -0.515245777483180456 -0.27940441114041408843 -0.42108499009560135251 + Step Temp PotEng c_1 c_1[1] c_1[2] c_1[3] + 200 0.75199164 -5.752864 -0.40524506 -0.51524578 -0.27940441 -0.42108499 + 300 0.75219392 -5.7527975 -0.41843911 -0.24280603 -0.42189159 -0.59061972 +Loop time of 0.278602 on 1 procs for 100 steps with 500 atoms + +Performance: 155060.058 tau/day, 358.935 timesteps/s +26.9% CPU use with 1 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.049067 | 0.049067 | 0.049067 | 0.0 | 17.61 +Neigh | 0.01894 | 0.01894 | 0.01894 | 0.0 | 6.80 +Comm | 0.0026936 | 0.0026936 | 0.0026936 | 0.0 | 0.97 +Output | 0.002919 | 0.002919 | 0.002919 | 0.0 | 1.05 +Modify | 0.20406 | 0.20406 | 0.20406 | 0.0 | 73.24 +Other | | 0.0009253 | | | 0.33 + +Nlocal: 500 ave 500 max 500 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 1898 ave 1898 max 1898 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 18744 ave 18744 max 18744 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 18744 +Ave neighs/atom = 37.488 +Neighbor list builds = 31 +Dangerous builds = 0 +print 'QM eng = $(f_2/atoms)' +QM eng = -5.7527974697327088904 +print 'QM virial = $(v_evirial) $(f_2[1]) $(f_2[2]) $(f_2[3])' +QM virial = -0.41843911315518900196 -0.24280603320322050043 -0.4218915869116203754 -0.59061971935072643536 +Total wall time: 0:00:01 diff --git a/examples/mdi/log.17Jun22.snapshot.driver.tcp.3 b/examples/mdi/log.17Jun22.snapshot.driver.tcp.3 new file mode 100644 index 0000000000..554c942b73 --- /dev/null +++ b/examples/mdi/log.17Jun22.snapshot.driver.tcp.3 @@ -0,0 +1,105 @@ +LAMMPS (2 Jun 2022) +# 3d Lennard-Jones melt - MDI driver script + +units lj +atom_style atomic + +read_data data.snapshot +Reading data file ... + orthogonal box = (0 0 0) to (8.397981 8.397981 8.397981) + 1 by 1 by 3 MPI processor grid + reading atoms ... + 500 atoms + reading velocities ... + 500 velocities + read_data CPU = 0.005 seconds + +velocity all create 1.44 87287 loop geom + +pair_style lj/cut 2.5 +pair_coeff 1 1 1.0 1.0 2.5 + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +fix 1 all nve + +fix 2 all mdi/qm add no every 100 virial yes + +compute 1 all pressure NULL virial +variable evirial equal (f_2[1]+f_2[2]+f_2[3])/3 + +thermo_style custom step temp pe c_1 c_1[1] c_1[2] c_1[3] + +thermo 100 + +dump 1 all custom 100 dump.snapshot.driver id type x y z f_2[1] f_2[2] f_2[3] +dump_modify 1 sort id + +run 300 pre no post no every 100 "print 'QM eng = $(f_2/atoms)'" "print 'QM virial = $(v_evirial) $(f_2[1]) $(f_2[2]) $(f_2[3])'" +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 2.8 + ghost atom cutoff = 2.8 + binsize = 1.4, bins = 6 6 6 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair lj/cut, perpetual + attributes: half, newton on + pair build: half/bin/atomonly/newton + stencil: half/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 4.417 | 4.422 | 4.425 Mbytes + Step Temp PotEng c_1 c_1[1] c_1[2] c_1[3] + 0 1.44 -6.7733681 -6.2353173 -6.2353173 -6.2353173 -6.2353173 + 100 0.75627629 -5.7579933 -0.4184022 -0.48020229 -0.33571704 -0.43928726 +Loop time of 0.271725 on 3 procs for 100 steps with 500 atoms + +print 'QM eng = $(f_2/atoms)' +QM eng = -5.7579933325734558025 +print 'QM virial = $(v_evirial) $(f_2[1]) $(f_2[2]) $(f_2[3])' +QM virial = -0.41840219542566797761 -0.4802022860820577832 -0.33571704057970208623 -0.43928725961524273114 + Step Temp PotEng c_1 c_1[1] c_1[2] c_1[3] + 100 0.75627629 -5.7579933 -0.4184022 -0.48020229 -0.33571704 -0.43928726 + 200 0.75199164 -5.752864 -0.40524506 -0.51524578 -0.27940441 -0.42108499 +Loop time of 0.275711 on 3 procs for 100 steps with 500 atoms + +print 'QM eng = $(f_2/atoms)' +QM eng = -5.752864010326673494 +print 'QM virial = $(v_evirial) $(f_2[1]) $(f_2[2]) $(f_2[3])' +QM virial = -0.40524505957305401171 -0.51524577748319133619 -0.27940441114042008364 -0.4210849900955495051 + Step Temp PotEng c_1 c_1[1] c_1[2] c_1[3] + 200 0.75199164 -5.752864 -0.40524506 -0.51524578 -0.27940441 -0.42108499 + 300 0.75219392 -5.7527975 -0.41843911 -0.24280603 -0.42189159 -0.59061972 +Loop time of 0.27674 on 3 procs for 100 steps with 500 atoms + +Performance: 156103.145 tau/day, 361.350 timesteps/s +71.1% CPU use with 3 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.0086137 | 0.01236 | 0.019756 | 4.7 | 4.47 +Neigh | 0.003253 | 0.0047355 | 0.0075676 | 2.9 | 1.71 +Comm | 0.0065383 | 0.016521 | 0.021738 | 5.5 | 5.97 +Output | 0.0011823 | 0.0011972 | 0.0012111 | 0.0 | 0.43 +Modify | 0.24066 | 0.24076 | 0.24093 | 0.0 | 87.00 +Other | | 0.001171 | | | 0.42 + +Nlocal: 166.667 ave 175 max 157 min +Histogram: 1 0 0 0 0 0 1 0 0 1 +Nghost: 1254.33 ave 1264 max 1246 min +Histogram: 1 0 0 1 0 0 0 0 0 1 +Neighs: 6248 ave 6632 max 5774 min +Histogram: 1 0 0 0 0 0 1 0 0 1 + +Total # of neighbors = 18744 +Ave neighs/atom = 37.488 +Neighbor list builds = 31 +Dangerous builds = 0 +print 'QM eng = $(f_2/atoms)' +QM eng = -5.752797469732716884 +print 'QM virial = $(v_evirial) $(f_2[1]) $(f_2[2]) $(f_2[3])' +QM virial = -0.41843911315521897798 -0.24280603320323970729 -0.42189158691169792448 -0.590619719350719663 +Total wall time: 0:00:01 diff --git a/examples/mdi/log.17Jun22.snapshot.engine.mpi.1 b/examples/mdi/log.17Jun22.snapshot.engine.mpi.1 new file mode 100644 index 0000000000..1480d238f0 --- /dev/null +++ b/examples/mdi/log.17Jun22.snapshot.engine.mpi.1 @@ -0,0 +1,45 @@ +LAMMPS (2 Jun 2022) +# 3d Lennard-Jones melt - MDI engine script + +units lj +atom_style atomic + +lattice fcc 1.0 +Lattice spacing in x,y,z = 1.5874011 1.5874011 1.5874011 +region box block 0 1 0 1 0 1 +create_box 1 box +Created orthogonal box = (0 0 0) to (1.5874011 1.5874011 1.5874011) + 1 by 1 by 1 MPI processor grid +mass 1 1.0 + +pair_style lj/cut 2.5 +pair_coeff 1 1 1.0 1.0 2.5 + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +mdi engine +delete_atoms group all +Deleted 0 atoms, new total = 0 + 1 by 1 by 1 MPI processor grid +WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 2.8 + ghost atom cutoff = 2.8 + binsize = 1.4, bins = 6 6 6 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair lj/cut, perpetual + attributes: half, newton on + pair build: half/bin/atomonly/newton + stencil: half/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 3.144 | 3.144 | 3.144 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 0 -6.7733681 0 -6.7733681 -6.2353173 + 1 0 -5.7579933 0 -5.7579933 -0.4184022 + 2 0 -5.752864 0 -5.752864 -0.40524506 + 3 0 -5.7527975 0 -5.7527975 -0.41843911 +Total wall time: 0:00:00 diff --git a/examples/mdi/log.17Jun22.snapshot.engine.mpi.3 b/examples/mdi/log.17Jun22.snapshot.engine.mpi.3 new file mode 100644 index 0000000000..0be8b75f70 --- /dev/null +++ b/examples/mdi/log.17Jun22.snapshot.engine.mpi.3 @@ -0,0 +1,45 @@ +LAMMPS (2 Jun 2022) +# 3d Lennard-Jones melt - MDI engine script + +units lj +atom_style atomic + +lattice fcc 1.0 +Lattice spacing in x,y,z = 1.5874011 1.5874011 1.5874011 +region box block 0 1 0 1 0 1 +create_box 1 box +Created orthogonal box = (0 0 0) to (1.5874011 1.5874011 1.5874011) + 1 by 2 by 2 MPI processor grid +mass 1 1.0 + +pair_style lj/cut 2.5 +pair_coeff 1 1 1.0 1.0 2.5 + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +mdi engine +delete_atoms group all +Deleted 0 atoms, new total = 0 + 1 by 2 by 2 MPI processor grid +WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 2.8 + ghost atom cutoff = 2.8 + binsize = 1.4, bins = 6 6 6 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair lj/cut, perpetual + attributes: half, newton on + pair build: half/bin/atomonly/newton + stencil: half/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 3.109 | 3.109 | 3.109 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 0 -6.7733681 0 -6.7733681 -6.2353173 + 1 0 -5.7579933 0 -5.7579933 -0.4184022 + 2 0 -5.752864 0 -5.752864 -0.40524506 + 3 0 -5.7527975 0 -5.7527975 -0.41843911 +Total wall time: 0:00:00 diff --git a/examples/mdi/log.17Jun22.snapshot.engine.plugin.1 b/examples/mdi/log.17Jun22.snapshot.engine.plugin.1 new file mode 100644 index 0000000000..1480d238f0 --- /dev/null +++ b/examples/mdi/log.17Jun22.snapshot.engine.plugin.1 @@ -0,0 +1,45 @@ +LAMMPS (2 Jun 2022) +# 3d Lennard-Jones melt - MDI engine script + +units lj +atom_style atomic + +lattice fcc 1.0 +Lattice spacing in x,y,z = 1.5874011 1.5874011 1.5874011 +region box block 0 1 0 1 0 1 +create_box 1 box +Created orthogonal box = (0 0 0) to (1.5874011 1.5874011 1.5874011) + 1 by 1 by 1 MPI processor grid +mass 1 1.0 + +pair_style lj/cut 2.5 +pair_coeff 1 1 1.0 1.0 2.5 + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +mdi engine +delete_atoms group all +Deleted 0 atoms, new total = 0 + 1 by 1 by 1 MPI processor grid +WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 2.8 + ghost atom cutoff = 2.8 + binsize = 1.4, bins = 6 6 6 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair lj/cut, perpetual + attributes: half, newton on + pair build: half/bin/atomonly/newton + stencil: half/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 3.144 | 3.144 | 3.144 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 0 -6.7733681 0 -6.7733681 -6.2353173 + 1 0 -5.7579933 0 -5.7579933 -0.4184022 + 2 0 -5.752864 0 -5.752864 -0.40524506 + 3 0 -5.7527975 0 -5.7527975 -0.41843911 +Total wall time: 0:00:00 diff --git a/examples/mdi/log.17Jun22.snapshot.engine.plugin.3 b/examples/mdi/log.17Jun22.snapshot.engine.plugin.3 new file mode 100644 index 0000000000..d1344cccbd --- /dev/null +++ b/examples/mdi/log.17Jun22.snapshot.engine.plugin.3 @@ -0,0 +1,45 @@ +LAMMPS (2 Jun 2022) +# 3d Lennard-Jones melt - MDI engine script + +units lj +atom_style atomic + +lattice fcc 1.0 +Lattice spacing in x,y,z = 1.5874011 1.5874011 1.5874011 +region box block 0 1 0 1 0 1 +create_box 1 box +Created orthogonal box = (0 0 0) to (1.5874011 1.5874011 1.5874011) + 1 by 1 by 3 MPI processor grid +mass 1 1.0 + +pair_style lj/cut 2.5 +pair_coeff 1 1 1.0 1.0 2.5 + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +mdi engine +delete_atoms group all +Deleted 0 atoms, new total = 0 + 1 by 1 by 3 MPI processor grid +WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 2.8 + ghost atom cutoff = 2.8 + binsize = 1.4, bins = 6 6 6 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair lj/cut, perpetual + attributes: half, newton on + pair build: half/bin/atomonly/newton + stencil: half/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 3.124 | 3.13 | 3.133 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 0 -6.7733681 0 -6.7733681 -6.2353173 + 1 0 -5.7579933 0 -5.7579933 -0.4184022 + 2 0 -5.752864 0 -5.752864 -0.40524506 + 3 0 -5.7527975 0 -5.7527975 -0.41843911 +Total wall time: 0:00:00 diff --git a/examples/mdi/log.17Jun22.snapshot.engine.tcp.1 b/examples/mdi/log.17Jun22.snapshot.engine.tcp.1 new file mode 100644 index 0000000000..4deaa0d0f1 --- /dev/null +++ b/examples/mdi/log.17Jun22.snapshot.engine.tcp.1 @@ -0,0 +1,45 @@ +LAMMPS (2 Jun 2022) +# 3d Lennard-Jones melt - MDI engine script + +units lj +atom_style atomic + +lattice fcc 1.0 +Lattice spacing in x,y,z = 1.5874011 1.5874011 1.5874011 +region box block 0 1 0 1 0 1 +create_box 1 box +Created orthogonal box = (0 0 0) to (1.5874011 1.5874011 1.5874011) + 1 by 1 by 1 MPI processor grid +mass 1 1.0 + +pair_style lj/cut 2.5 +pair_coeff 1 1 1.0 1.0 2.5 + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +mdi engine +delete_atoms group all +Deleted 0 atoms, new total = 0 + 1 by 1 by 1 MPI processor grid +WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 2.8 + ghost atom cutoff = 2.8 + binsize = 1.4, bins = 6 6 6 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair lj/cut, perpetual + attributes: half, newton on + pair build: half/bin/atomonly/newton + stencil: half/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 3.144 | 3.144 | 3.144 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 0 -6.7733681 0 -6.7733681 -6.2353173 + 1 0 -5.7579933 0 -5.7579933 -0.4184022 + 2 0 -5.752864 0 -5.752864 -0.40524506 + 3 0 -5.7527975 0 -5.7527975 -0.41843911 +Total wall time: 0:00:01 diff --git a/examples/mdi/log.17Jun22.snapshot.engine.tcp.4 b/examples/mdi/log.17Jun22.snapshot.engine.tcp.4 new file mode 100644 index 0000000000..2af1319e58 --- /dev/null +++ b/examples/mdi/log.17Jun22.snapshot.engine.tcp.4 @@ -0,0 +1,45 @@ +LAMMPS (2 Jun 2022) +# 3d Lennard-Jones melt - MDI engine script + +units lj +atom_style atomic + +lattice fcc 1.0 +Lattice spacing in x,y,z = 1.5874011 1.5874011 1.5874011 +region box block 0 1 0 1 0 1 +create_box 1 box +Created orthogonal box = (0 0 0) to (1.5874011 1.5874011 1.5874011) + 1 by 2 by 2 MPI processor grid +mass 1 1.0 + +pair_style lj/cut 2.5 +pair_coeff 1 1 1.0 1.0 2.5 + +neighbor 0.3 bin +neigh_modify delay 0 every 1 check yes + +mdi engine +delete_atoms group all +Deleted 0 atoms, new total = 0 + 1 by 2 by 2 MPI processor grid +WARNING: No fixes with time integration, atoms won't move (../verlet.cpp:60) +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 2.8 + ghost atom cutoff = 2.8 + binsize = 1.4, bins = 6 6 6 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair lj/cut, perpetual + attributes: half, newton on + pair build: half/bin/atomonly/newton + stencil: half/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 3.109 | 3.109 | 3.109 Mbytes + Step Temp E_pair E_mol TotEng Press + 0 0 -6.7733681 0 -6.7733681 -6.2353173 + 1 0 -5.7579933 0 -5.7579933 -0.4184022 + 2 0 -5.752864 0 -5.752864 -0.40524506 + 3 0 -5.7527975 0 -5.7527975 -0.41843911 +Total wall time: 0:00:01 From dac99e462ffb7891c15a59074d39c89b53a1a5d4 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 17 Jun 2022 13:04:25 -0400 Subject: [PATCH 388/585] update log files --- examples/snap/log.15Jun22.grid.snap.g++.1 | 46 +++++++++------------ examples/snap/log.15Jun22.grid.snap.g++.4 | 48 +++++++++------------- examples/snap/log.15Jun22.grid.tri.g++.1 | 50 ++++++++++------------- examples/snap/log.15Jun22.grid.tri.g++.4 | 50 ++++++++++------------- 4 files changed, 81 insertions(+), 113 deletions(-) diff --git a/examples/snap/log.15Jun22.grid.snap.g++.1 b/examples/snap/log.15Jun22.grid.snap.g++.1 index 71b884d1b6..ec2026b16e 100644 --- a/examples/snap/log.15Jun22.grid.snap.g++.1 +++ b/examples/snap/log.15Jun22.grid.snap.g++.1 @@ -1,4 +1,5 @@ -LAMMPS (28 Jul 2021) +LAMMPS (2 Jun 2022) + using 1 OpenMP thread(s) per MPI task # Demonstrate calculation of SNAP bispectrum descriptors on a grid # CORRECTNESS: The two atom positions coincide with two of @@ -27,17 +28,17 @@ boundary p p p lattice custom $a a1 1 0 0 a2 0 1 0 a3 0 0 1 basis 0 0 0 basis 0.5 0.5 0.5 lattice custom 3.316 a1 1 0 0 a2 0 1 0 a3 0 0 1 basis 0 0 0 basis 0.5 0.5 0.5 -Lattice spacing in x,y,z = 3.3160000 3.3160000 3.3160000 +Lattice spacing in x,y,z = 3.316 3.316 3.316 region box block 0 ${nx} 0 ${ny} 0 ${nz} region box block 0 1 0 ${ny} 0 ${nz} region box block 0 1 0 1 0 ${nz} region box block 0 1 0 1 0 1 create_box 1 box -Created orthogonal box = (0.0000000 0.0000000 0.0000000) to (3.3160000 3.3160000 3.3160000) +Created orthogonal box = (0 0 0) to (3.316 3.316 3.316) 1 by 1 by 1 MPI processor grid create_atoms 1 box Created 2 atoms - using lattice units in orthogonal box = (0.0000000 0.0000000 0.0000000) to (3.3160000 3.3160000 3.3160000) + using lattice units in orthogonal box = (0 0 0) to (3.316 3.316 3.316) create_atoms CPU = 0.000 seconds mass 1 180.88 @@ -105,14 +106,15 @@ dump 2 all custom 1000 dump.batom id x y z c_b[*] # run run 0 -WARNING: No fixes defined, atoms won't move (src/verlet.cpp:55) +WARNING: No fixes with time integration, atoms won't move (src/verlet.cpp:60) +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule Neighbor list info ... update every 1 steps, delay 10 steps, check yes max neighbors/atom: 2000, page size: 100000 master list distance cutoff = 6.67637 ghost atom cutoff = 6.67637 binsize = 3.338185, bins = 1 1 1 - 4 neighbor lists, perpetual/occasional/extra = 1 3 0 + 2 neighbor lists, perpetual/occasional/extra = 1 1 0 (1) pair zero, perpetual attributes: half, newton on pair build: half/bin/atomonly/newton @@ -123,22 +125,12 @@ Neighbor list info ... pair build: full/bin/atomonly stencil: full/bin/3d bin: standard - (3) compute sna/grid, occasional - attributes: full, newton on - pair build: full/bin/atomonly - stencil: full/bin/3d - bin: standard - (4) compute sna/grid/local, occasional - attributes: full, newton on - pair build: full/bin/atomonly - stencil: full/bin/3d - bin: standard -Per MPI rank memory allocation (min/avg/max) = 8.384 | 8.384 | 8.384 Mbytes -Step v_B5atom v_B5grid v_rmse_global - 0 1.0427295 1.0427295 0 -Loop time of 1e-06 on 1 procs for 0 steps with 2 atoms +Per MPI rank memory allocation (min/avg/max) = 7.127 | 7.127 | 7.127 Mbytes + Step v_B5atom v_B5grid v_rmse_global + 0 1.0427295 1.0427295 9.1551336e-16 +Loop time of 1.43e-06 on 1 procs for 0 steps with 2 atoms -100.0% CPU use with 1 MPI tasks x no OpenMP threads +139.9% CPU use with 1 MPI tasks x 1 OpenMP threads MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total @@ -148,19 +140,19 @@ Neigh | 0 | 0 | 0 | 0.0 | 0.00 Comm | 0 | 0 | 0 | 0.0 | 0.00 Output | 0 | 0 | 0 | 0.0 | 0.00 Modify | 0 | 0 | 0 | 0.0 | 0.00 -Other | | 1e-06 | | |100.00 +Other | | 1.43e-06 | | |100.00 -Nlocal: 2.00000 ave 2 max 2 min +Nlocal: 2 ave 2 max 2 min Histogram: 1 0 0 0 0 0 0 0 0 0 -Nghost: 339.000 ave 339 max 339 min +Nghost: 339 ave 339 max 339 min Histogram: 1 0 0 0 0 0 0 0 0 0 -Neighs: 64.0000 ave 64 max 64 min +Neighs: 64 ave 64 max 64 min Histogram: 1 0 0 0 0 0 0 0 0 0 -FullNghs: 128.000 ave 128 max 128 min +FullNghs: 128 ave 128 max 128 min Histogram: 1 0 0 0 0 0 0 0 0 0 Total # of neighbors = 128 -Ave neighs/atom = 64.000000 +Ave neighs/atom = 64 Neighbor list builds = 0 Dangerous builds = 0 diff --git a/examples/snap/log.15Jun22.grid.snap.g++.4 b/examples/snap/log.15Jun22.grid.snap.g++.4 index 80761fc395..5be17ada7d 100644 --- a/examples/snap/log.15Jun22.grid.snap.g++.4 +++ b/examples/snap/log.15Jun22.grid.snap.g++.4 @@ -1,4 +1,5 @@ -LAMMPS (28 Jul 2021) +LAMMPS (2 Jun 2022) + using 1 OpenMP thread(s) per MPI task # Demonstrate calculation of SNAP bispectrum descriptors on a grid # CORRECTNESS: The two atom positions coincide with two of @@ -27,17 +28,17 @@ boundary p p p lattice custom $a a1 1 0 0 a2 0 1 0 a3 0 0 1 basis 0 0 0 basis 0.5 0.5 0.5 lattice custom 3.316 a1 1 0 0 a2 0 1 0 a3 0 0 1 basis 0 0 0 basis 0.5 0.5 0.5 -Lattice spacing in x,y,z = 3.3160000 3.3160000 3.3160000 +Lattice spacing in x,y,z = 3.316 3.316 3.316 region box block 0 ${nx} 0 ${ny} 0 ${nz} region box block 0 1 0 ${ny} 0 ${nz} region box block 0 1 0 1 0 ${nz} region box block 0 1 0 1 0 1 create_box 1 box -Created orthogonal box = (0.0000000 0.0000000 0.0000000) to (3.3160000 3.3160000 3.3160000) +Created orthogonal box = (0 0 0) to (3.316 3.316 3.316) 1 by 2 by 2 MPI processor grid create_atoms 1 box Created 2 atoms - using lattice units in orthogonal box = (0.0000000 0.0000000 0.0000000) to (3.3160000 3.3160000 3.3160000) + using lattice units in orthogonal box = (0 0 0) to (3.316 3.316 3.316) create_atoms CPU = 0.001 seconds mass 1 180.88 @@ -105,14 +106,15 @@ dump 2 all custom 1000 dump.batom id x y z c_b[*] # run run 0 -WARNING: No fixes defined, atoms won't move (src/verlet.cpp:55) +WARNING: No fixes with time integration, atoms won't move (src/verlet.cpp:60) +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule Neighbor list info ... update every 1 steps, delay 10 steps, check yes max neighbors/atom: 2000, page size: 100000 master list distance cutoff = 6.67637 ghost atom cutoff = 6.67637 binsize = 3.338185, bins = 1 1 1 - 4 neighbor lists, perpetual/occasional/extra = 1 3 0 + 2 neighbor lists, perpetual/occasional/extra = 1 1 0 (1) pair zero, perpetual attributes: half, newton on pair build: half/bin/atomonly/newton @@ -123,23 +125,13 @@ Neighbor list info ... pair build: full/bin/atomonly stencil: full/bin/3d bin: standard - (3) compute sna/grid, occasional - attributes: full, newton on - pair build: full/bin/atomonly - stencil: full/bin/3d - bin: standard - (4) compute sna/grid/local, occasional - attributes: full, newton on - pair build: full/bin/atomonly - stencil: full/bin/3d - bin: standard -WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (src/domain.cpp:964) -Per MPI rank memory allocation (min/avg/max) = 7.381 | 7.889 | 8.397 Mbytes -Step v_B5atom v_B5grid v_rmse_global - 0 1.0427295 1.0427295 0 -Loop time of 1.5e-06 on 4 procs for 0 steps with 2 atoms +WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (src/domain.cpp:970) +Per MPI rank memory allocation (min/avg/max) = 6.123 | 6.631 | 7.139 Mbytes + Step v_B5atom v_B5grid v_rmse_global + 0 1.0427295 1.0427295 1.6316879e-15 +Loop time of 2.57125e-06 on 4 procs for 0 steps with 2 atoms -83.3% CPU use with 4 MPI tasks x no OpenMP threads +107.0% CPU use with 4 MPI tasks x 1 OpenMP threads MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total @@ -149,19 +141,19 @@ Neigh | 0 | 0 | 0 | 0.0 | 0.00 Comm | 0 | 0 | 0 | 0.0 | 0.00 Output | 0 | 0 | 0 | 0.0 | 0.00 Modify | 0 | 0 | 0 | 0.0 | 0.00 -Other | | 1.5e-06 | | |100.00 +Other | | 2.571e-06 | | |100.00 -Nlocal: 0.500000 ave 1 max 0 min +Nlocal: 0.5 ave 1 max 0 min Histogram: 2 0 0 0 0 0 0 0 0 2 -Nghost: 274.500 ave 275 max 274 min +Nghost: 274.5 ave 275 max 274 min Histogram: 2 0 0 0 0 0 0 0 0 2 -Neighs: 16.0000 ave 40 max 0 min +Neighs: 16 ave 40 max 0 min Histogram: 2 0 0 0 0 0 1 0 0 1 -FullNghs: 32.0000 ave 64 max 0 min +FullNghs: 32 ave 64 max 0 min Histogram: 2 0 0 0 0 0 0 0 0 2 Total # of neighbors = 128 -Ave neighs/atom = 64.000000 +Ave neighs/atom = 64 Neighbor list builds = 0 Dangerous builds = 0 diff --git a/examples/snap/log.15Jun22.grid.tri.g++.1 b/examples/snap/log.15Jun22.grid.tri.g++.1 index c261154367..e26315235b 100644 --- a/examples/snap/log.15Jun22.grid.tri.g++.1 +++ b/examples/snap/log.15Jun22.grid.tri.g++.1 @@ -1,4 +1,5 @@ -LAMMPS (28 Jul 2021) +LAMMPS (2 Jun 2022) + using 1 OpenMP thread(s) per MPI task # Demonstrate calculation of SNAP bispectrum # descriptors on a grid for triclinic cell @@ -51,7 +52,7 @@ boundary p p p lattice custom $a a1 1 0 0 a2 1 1 0 a3 1 1 1 basis 0 0 0 basis 0.0 0.0 0.5 spacing 1 1 1 lattice custom 3.316 a1 1 0 0 a2 1 1 0 a3 1 1 1 basis 0 0 0 basis 0.0 0.0 0.5 spacing 1 1 1 -Lattice spacing in x,y,z = 3.3160000 3.3160000 3.3160000 +Lattice spacing in x,y,z = 3.316 3.316 3.316 box tilt large region box prism 0 ${nx} 0 ${ny} 0 ${nz} ${ny} ${nz} ${nz} @@ -62,13 +63,13 @@ region box prism 0 3 0 2 0 1 2 ${nz} ${nz} region box prism 0 3 0 2 0 1 2 1 ${nz} region box prism 0 3 0 2 0 1 2 1 1 create_box 1 box -Created triclinic box = (0.0000000 0.0000000 0.0000000) to (9.9480000 6.6320000 3.3160000) with tilt (6.6320000 3.3160000 3.3160000) -WARNING: Triclinic box skew is large (src/domain.cpp:219) +Created triclinic box = (0 0 0) to (9.948 6.632 3.316) with tilt (6.632 3.316 3.316) +WARNING: Triclinic box skew is large (src/domain.cpp:224) 1 by 1 by 1 MPI processor grid create_atoms 1 box Created 12 atoms - using lattice units in triclinic box = (0.0000000 0.0000000 0.0000000) to (9.9480000 6.6320000 3.3160000) with tilt (6.6320000 3.3160000 3.3160000) - create_atoms CPU = 0.001 seconds + using lattice units in triclinic box = (0 0 0) to (9.948 6.632 3.316) with tilt (6.632 3.316 3.316) + create_atoms CPU = 0.000 seconds mass 1 180.88 @@ -138,14 +139,15 @@ dump 2 all custom 1000 dump.batom.tri id x y z c_b[*] # run run 0 -WARNING: No fixes defined, atoms won't move (src/verlet.cpp:55) +WARNING: No fixes with time integration, atoms won't move (src/verlet.cpp:60) +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule Neighbor list info ... update every 1 steps, delay 10 steps, check yes max neighbors/atom: 2000, page size: 100000 master list distance cutoff = 6.67637 ghost atom cutoff = 6.67637 binsize = 3.338185, bins = 6 3 1 - 4 neighbor lists, perpetual/occasional/extra = 1 3 0 + 2 neighbor lists, perpetual/occasional/extra = 1 1 0 (1) pair zero, perpetual attributes: half, newton on pair build: half/bin/newton/tri @@ -156,22 +158,12 @@ Neighbor list info ... pair build: full/bin/atomonly stencil: full/bin/3d bin: standard - (3) compute sna/grid, occasional - attributes: full, newton on - pair build: full/bin/atomonly - stencil: full/bin/3d - bin: standard - (4) compute sna/grid/local, occasional - attributes: full, newton on - pair build: full/bin/atomonly - stencil: full/bin/3d - bin: standard -Per MPI rank memory allocation (min/avg/max) = 8.435 | 8.435 | 8.435 Mbytes -Step v_B5atom v_B5grid v_rmse_global - 0 1.0427295 1.0427295 7.2262471e-14 -Loop time of 1e-06 on 1 procs for 0 steps with 12 atoms +Per MPI rank memory allocation (min/avg/max) = 7.183 | 7.183 | 7.183 Mbytes + Step v_B5atom v_B5grid v_rmse_global + 0 1.0427295 1.0427295 7.2262471e-14 +Loop time of 1.414e-06 on 1 procs for 0 steps with 12 atoms -100.0% CPU use with 1 MPI tasks x no OpenMP threads +70.7% CPU use with 1 MPI tasks x 1 OpenMP threads MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total @@ -181,19 +173,19 @@ Neigh | 0 | 0 | 0 | 0.0 | 0.00 Comm | 0 | 0 | 0 | 0.0 | 0.00 Output | 0 | 0 | 0 | 0.0 | 0.00 Modify | 0 | 0 | 0 | 0.0 | 0.00 -Other | | 1e-06 | | |100.00 +Other | | 1.414e-06 | | |100.00 -Nlocal: 12.0000 ave 12 max 12 min +Nlocal: 12 ave 12 max 12 min Histogram: 1 0 0 0 0 0 0 0 0 0 -Nghost: 604.000 ave 604 max 604 min +Nghost: 604 ave 604 max 604 min Histogram: 1 0 0 0 0 0 0 0 0 0 -Neighs: 384.000 ave 384 max 384 min +Neighs: 384 ave 384 max 384 min Histogram: 1 0 0 0 0 0 0 0 0 0 -FullNghs: 768.000 ave 768 max 768 min +FullNghs: 768 ave 768 max 768 min Histogram: 1 0 0 0 0 0 0 0 0 0 Total # of neighbors = 768 -Ave neighs/atom = 64.000000 +Ave neighs/atom = 64 Neighbor list builds = 0 Dangerous builds = 0 diff --git a/examples/snap/log.15Jun22.grid.tri.g++.4 b/examples/snap/log.15Jun22.grid.tri.g++.4 index bac7ecaa5a..cee3ce7f12 100644 --- a/examples/snap/log.15Jun22.grid.tri.g++.4 +++ b/examples/snap/log.15Jun22.grid.tri.g++.4 @@ -1,4 +1,5 @@ -LAMMPS (28 Jul 2021) +LAMMPS (2 Jun 2022) + using 1 OpenMP thread(s) per MPI task # Demonstrate calculation of SNAP bispectrum # descriptors on a grid for triclinic cell @@ -51,7 +52,7 @@ boundary p p p lattice custom $a a1 1 0 0 a2 1 1 0 a3 1 1 1 basis 0 0 0 basis 0.0 0.0 0.5 spacing 1 1 1 lattice custom 3.316 a1 1 0 0 a2 1 1 0 a3 1 1 1 basis 0 0 0 basis 0.0 0.0 0.5 spacing 1 1 1 -Lattice spacing in x,y,z = 3.3160000 3.3160000 3.3160000 +Lattice spacing in x,y,z = 3.316 3.316 3.316 box tilt large region box prism 0 ${nx} 0 ${ny} 0 ${nz} ${ny} ${nz} ${nz} @@ -62,13 +63,13 @@ region box prism 0 3 0 2 0 1 2 ${nz} ${nz} region box prism 0 3 0 2 0 1 2 1 ${nz} region box prism 0 3 0 2 0 1 2 1 1 create_box 1 box -Created triclinic box = (0.0000000 0.0000000 0.0000000) to (9.9480000 6.6320000 3.3160000) with tilt (6.6320000 3.3160000 3.3160000) -WARNING: Triclinic box skew is large (src/domain.cpp:219) +Created triclinic box = (0 0 0) to (9.948 6.632 3.316) with tilt (6.632 3.316 3.316) +WARNING: Triclinic box skew is large (src/domain.cpp:224) 2 by 2 by 1 MPI processor grid create_atoms 1 box Created 12 atoms - using lattice units in triclinic box = (0.0000000 0.0000000 0.0000000) to (9.9480000 6.6320000 3.3160000) with tilt (6.6320000 3.3160000 3.3160000) - create_atoms CPU = 0.001 seconds + using lattice units in triclinic box = (0 0 0) to (9.948 6.632 3.316) with tilt (6.632 3.316 3.316) + create_atoms CPU = 0.000 seconds mass 1 180.88 @@ -138,14 +139,15 @@ dump 2 all custom 1000 dump.batom.tri id x y z c_b[*] # run run 0 -WARNING: No fixes defined, atoms won't move (src/verlet.cpp:55) +WARNING: No fixes with time integration, atoms won't move (src/verlet.cpp:60) +Generated 0 of 0 mixed pair_coeff terms from geometric mixing rule Neighbor list info ... update every 1 steps, delay 10 steps, check yes max neighbors/atom: 2000, page size: 100000 master list distance cutoff = 6.67637 ghost atom cutoff = 6.67637 binsize = 3.338185, bins = 6 3 1 - 4 neighbor lists, perpetual/occasional/extra = 1 3 0 + 2 neighbor lists, perpetual/occasional/extra = 1 1 0 (1) pair zero, perpetual attributes: half, newton on pair build: half/bin/newton/tri @@ -156,22 +158,12 @@ Neighbor list info ... pair build: full/bin/atomonly stencil: full/bin/3d bin: standard - (3) compute sna/grid, occasional - attributes: full, newton on - pair build: full/bin/atomonly - stencil: full/bin/3d - bin: standard - (4) compute sna/grid/local, occasional - attributes: full, newton on - pair build: full/bin/atomonly - stencil: full/bin/3d - bin: standard -Per MPI rank memory allocation (min/avg/max) = 8.405 | 8.405 | 8.405 Mbytes -Step v_B5atom v_B5grid v_rmse_global - 0 1.0427295 1.0427295 2.1052124e-14 -Loop time of 1.25e-06 on 4 procs for 0 steps with 12 atoms +Per MPI rank memory allocation (min/avg/max) = 7.15 | 7.15 | 7.15 Mbytes + Step v_B5atom v_B5grid v_rmse_global + 0 1.0427295 1.0427295 1.9367585e-14 +Loop time of 2.65825e-06 on 4 procs for 0 steps with 12 atoms -140.0% CPU use with 4 MPI tasks x no OpenMP threads +84.6% CPU use with 4 MPI tasks x 1 OpenMP threads MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total @@ -181,19 +173,19 @@ Neigh | 0 | 0 | 0 | 0.0 | 0.00 Comm | 0 | 0 | 0 | 0.0 | 0.00 Output | 0 | 0 | 0 | 0.0 | 0.00 Modify | 0 | 0 | 0 | 0.0 | 0.00 -Other | | 1.25e-06 | | |100.00 +Other | | 2.658e-06 | | |100.00 -Nlocal: 3.00000 ave 4 max 2 min +Nlocal: 3 ave 4 max 2 min Histogram: 2 0 0 0 0 0 0 0 0 2 -Nghost: 459.000 ave 460 max 458 min +Nghost: 459 ave 460 max 458 min Histogram: 2 0 0 0 0 0 0 0 0 2 -Neighs: 96.0000 ave 128 max 64 min +Neighs: 96 ave 128 max 64 min Histogram: 2 0 0 0 0 0 0 0 0 2 -FullNghs: 192.000 ave 256 max 128 min +FullNghs: 192 ave 256 max 128 min Histogram: 2 0 0 0 0 0 0 0 0 2 Total # of neighbors = 768 -Ave neighs/atom = 64.000000 +Ave neighs/atom = 64 Neighbor list builds = 0 Dangerous builds = 0 From 378511345aefb7a6ac4de0ea29281f1b92a007eb Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Fri, 17 Jun 2022 11:06:22 -0600 Subject: [PATCH 389/585] pass ID list to create_atoms from MDI --- src/MDI/fix_mdi_qm.cpp | 1 + src/MDI/mdi_engine.cpp | 11 +++++++++-- 2 files changed, 10 insertions(+), 2 deletions(-) diff --git a/src/MDI/fix_mdi_qm.cpp b/src/MDI/fix_mdi_qm.cpp index e819087844..38b7270651 100644 --- a/src/MDI/fix_mdi_qm.cpp +++ b/src/MDI/fix_mdi_qm.cpp @@ -316,6 +316,7 @@ void FixMDIQM::post_force(int vflag) fqm[i][2] = buf3[3 * index + 2] * mdi2lmp_force; } + // optionally add forces to owned atoms // use atomID of local atoms to index into ordered buf3 diff --git a/src/MDI/mdi_engine.cpp b/src/MDI/mdi_engine.cpp index 6a58512cfa..3683e3f3c5 100644 --- a/src/MDI/mdi_engine.cpp +++ b/src/MDI/mdi_engine.cpp @@ -955,16 +955,23 @@ void MDIEngine::create_system() lammps_reset_box(lmp, boxlo, boxhi, xy, yz, xz); // invoke lib->create_atoms() + // create list of 1 to sys_natoms IDs // optionally set charges if specified by ">CHARGES" + tagint* sys_ids; + memory->create(sys_ids, sys_natoms, "mdi:sys_ids"); + for (int i = 0; i < sys_natoms; i++) sys_ids[i] = i+1; + if (flag_velocities) - lammps_create_atoms(lmp, sys_natoms, nullptr, sys_types, sys_coords, sys_velocities, nullptr, + lammps_create_atoms(lmp, sys_natoms, sys_ids, sys_types, sys_coords, sys_velocities, nullptr, 1); else - lammps_create_atoms(lmp, sys_natoms, nullptr, sys_types, sys_coords, nullptr, nullptr, 1); + lammps_create_atoms(lmp, sys_natoms, sys_ids, sys_types, sys_coords, nullptr, nullptr, 1); if (flag_charges) lammps_scatter_atoms(lmp, (char *) "q", 1, 1, sys_charges); + memory->destroy(sys_ids); + // new system update->ntimestep = 0; From 5b9c4069e976edbcc0a7d45e20eec42c4a0f52d1 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 17 Jun 2022 13:25:29 -0400 Subject: [PATCH 390/585] make headers clang-format compatible and use override keywords --- src/ML-SNAP/compute_sna_grid.h | 16 ++++++++-------- src/ML-SNAP/compute_sna_grid_local.h | 16 ++++++++-------- src/compute_grid.h | 11 +++++------ src/compute_grid_local.h | 11 +++++------ 4 files changed, 26 insertions(+), 28 deletions(-) diff --git a/src/ML-SNAP/compute_sna_grid.h b/src/ML-SNAP/compute_sna_grid.h index 9bc3da8112..750f779a00 100644 --- a/src/ML-SNAP/compute_sna_grid.h +++ b/src/ML-SNAP/compute_sna_grid.h @@ -12,9 +12,9 @@ ------------------------------------------------------------------------- */ #ifdef COMPUTE_CLASS - -ComputeStyle(sna/grid,ComputeSNAGrid) - +// clang-format off +ComputeStyle(sna/grid,ComputeSNAGrid); +// clang-format on #else #ifndef LMP_COMPUTE_SNA_GRID_H @@ -27,11 +27,11 @@ namespace LAMMPS_NS { class ComputeSNAGrid : public ComputeGrid { public: ComputeSNAGrid(class LAMMPS *, int, char **); - ~ComputeSNAGrid(); - void init(); - void init_list(int, class NeighList *); - void compute_array(); - double memory_usage(); + ~ComputeSNAGrid() override; + void init() override; + void init_list(int, class NeighList *) override; + void compute_array() override; + double memory_usage() override; private: int ncoeff; diff --git a/src/ML-SNAP/compute_sna_grid_local.h b/src/ML-SNAP/compute_sna_grid_local.h index 69a2c528fc..c7678d049e 100644 --- a/src/ML-SNAP/compute_sna_grid_local.h +++ b/src/ML-SNAP/compute_sna_grid_local.h @@ -12,9 +12,9 @@ ------------------------------------------------------------------------- */ #ifdef COMPUTE_CLASS - -ComputeStyle(sna/grid/local,ComputeSNAGridLocal) - +// clang-format off +ComputeStyle(sna/grid/local,ComputeSNAGridLocal); +// clang-format on #else #ifndef LMP_COMPUTE_SNA_GRID_LOCAL_H @@ -27,11 +27,11 @@ namespace LAMMPS_NS { class ComputeSNAGridLocal : public ComputeGridLocal { public: ComputeSNAGridLocal(class LAMMPS *, int, char **); - ~ComputeSNAGridLocal(); - void init(); - void init_list(int, class NeighList *); - void compute_local(); - double memory_usage(); + ~ComputeSNAGridLocal() override; + void init() override; + void init_list(int, class NeighList *) override; + void compute_local() override; + double memory_usage() override; private: int ncoeff; diff --git a/src/compute_grid.h b/src/compute_grid.h index b0214b2b15..4264039cc8 100644 --- a/src/compute_grid.h +++ b/src/compute_grid.h @@ -22,12 +22,12 @@ class ComputeGrid : public Compute { public: ComputeGrid(class LAMMPS *, int, char **); - virtual ~ComputeGrid(); - void init(); - void setup(); - virtual void compute_array() = 0; + ~ComputeGrid() override; + void init() override; + void setup() override; + void compute_array() override = 0; - double memory_usage(); + double memory_usage() override; protected: int nx, ny, nz; // global grid dimensions @@ -53,7 +53,6 @@ class ComputeGrid : public Compute { void assign_coords_all(); // assign coords for global grid void set_grid_global(); // set global grid void set_grid_local(); // set bounds for local grid - private: }; } diff --git a/src/compute_grid_local.h b/src/compute_grid_local.h index 5c5611250b..2989628d79 100644 --- a/src/compute_grid_local.h +++ b/src/compute_grid_local.h @@ -22,12 +22,12 @@ class ComputeGridLocal : public Compute { public: ComputeGridLocal(class LAMMPS *, int, char **); - virtual ~ComputeGridLocal(); - void init(); - void setup(); - virtual void compute_local() = 0; + ~ComputeGridLocal() override; + void init() override; + void setup() override; + void compute_local() override = 0; - double memory_usage(); + double memory_usage() override; protected: int nx, ny, nz; // global grid dimensions @@ -51,7 +51,6 @@ class ComputeGridLocal : public Compute { void set_grid_global(); // set global grid void set_grid_local(); // set bounds for local grid void assign_coords(); // assign coords for grid - private: }; } From d9646ee537d642f72e3de20b4c3cf26d94c44a3d Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 17 Jun 2022 13:25:40 -0400 Subject: [PATCH 391/585] remove dead code --- src/ML-SNAP/compute_sna_grid.cpp | 1 - src/ML-SNAP/compute_sna_grid_local.cpp | 1 - 2 files changed, 2 deletions(-) diff --git a/src/ML-SNAP/compute_sna_grid.cpp b/src/ML-SNAP/compute_sna_grid.cpp index 8247771493..5ea49469e2 100644 --- a/src/ML-SNAP/compute_sna_grid.cpp +++ b/src/ML-SNAP/compute_sna_grid.cpp @@ -255,7 +255,6 @@ void ComputeSNAGrid::compute_array() int ielem = 0; if (chemflag) ielem = map[itype]; - const double radi = radelem[itype]; // rij[][3] = displacements between atom I and those neighbors // inside = indices of neighbors of I within cutoff diff --git a/src/ML-SNAP/compute_sna_grid_local.cpp b/src/ML-SNAP/compute_sna_grid_local.cpp index 70b5b362d8..614880043c 100644 --- a/src/ML-SNAP/compute_sna_grid_local.cpp +++ b/src/ML-SNAP/compute_sna_grid_local.cpp @@ -254,7 +254,6 @@ void ComputeSNAGridLocal::compute_local() int ielem = 0; if (chemflag) ielem = map[itype]; - const double radi = radelem[itype]; // rij[][3] = displacements between atom I and those neighbors // inside = indices of neighbors of I within cutoff From 9fd6bde0ed8f5f1c040d67b2c0f8c3092e13db7a Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 17 Jun 2022 13:47:23 -0400 Subject: [PATCH 392/585] enable and apply clang-format --- src/ML-SNAP/compute_sna_grid.cpp | 200 ++++++++++++------------- src/ML-SNAP/compute_sna_grid.h | 2 +- src/ML-SNAP/compute_sna_grid_local.cpp | 193 +++++++++++------------- src/ML-SNAP/compute_sna_grid_local.h | 2 +- src/compute_grid.cpp | 121 +++++++-------- src/compute_grid.h | 47 +++--- src/compute_grid_local.cpp | 107 +++++++------ src/compute_grid_local.h | 43 +++--- 8 files changed, 337 insertions(+), 378 deletions(-) diff --git a/src/ML-SNAP/compute_sna_grid.cpp b/src/ML-SNAP/compute_sna_grid.cpp index 5ea49469e2..e182b16d64 100644 --- a/src/ML-SNAP/compute_sna_grid.cpp +++ b/src/ML-SNAP/compute_sna_grid.cpp @@ -11,22 +11,22 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include "compute_grid.h" #include "compute_sna_grid.h" -#include "sna.h" + #include "atom.h" -#include "update.h" +#include "comm.h" +#include "domain.h" +#include "error.h" +#include "force.h" +#include "memory.h" #include "modify.h" -#include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" -#include "force.h" +#include "neighbor.h" #include "pair.h" -#include "domain.h" -#include "comm.h" -#include "memory.h" -#include "error.h" +#include "sna.h" #include "tokenizer.h" +#include "update.h" #include #include @@ -34,8 +34,7 @@ using namespace LAMMPS_NS; ComputeSNAGrid::ComputeSNAGrid(LAMMPS *lmp, int narg, char **arg) : - ComputeGrid(lmp, narg, arg), cutsq(nullptr), - radelem(nullptr), wjelem(nullptr) + ComputeGrid(lmp, narg, arg), cutsq(nullptr), radelem(nullptr), wjelem(nullptr) { double rfac0, rmin0; int twojmax, switchflag, bzeroflag, bnormflag, wselfallflag; @@ -48,9 +47,9 @@ ComputeSNAGrid::ComputeSNAGrid(LAMMPS *lmp, int narg, char **arg) : narg -= nargbase; int ntypes = atom->ntypes; - int nargmin = 6+2*ntypes; + int nargmin = 6 + 2 * ntypes; - if (narg < nargmin) error->all(FLERR,"Illegal compute sna/grid command"); + if (narg < nargmin) error->all(FLERR, "Illegal compute sna/grid command"); // default values @@ -66,30 +65,28 @@ ComputeSNAGrid::ComputeSNAGrid(LAMMPS *lmp, int narg, char **arg) : // process required arguments - memory->create(radelem,ntypes+1,"sna/grid:radelem"); // offset by 1 to match up with types - memory->create(wjelem,ntypes+1,"sna/grid:wjelem"); + memory->create(radelem, ntypes + 1, "sna/grid:radelem"); // offset by 1 to match up with types + memory->create(wjelem, ntypes + 1, "sna/grid:wjelem"); rcutfac = atof(arg[3]); rfac0 = atof(arg[4]); twojmax = atoi(arg[5]); - for(int i = 0; i < ntypes; i++) - radelem[i+1] = atof(arg[6+i]); - for(int i = 0; i < ntypes; i++) - wjelem[i+1] = atof(arg[6+ntypes+i]); + for (int i = 0; i < ntypes; i++) radelem[i + 1] = atof(arg[6 + i]); + for (int i = 0; i < ntypes; i++) wjelem[i + 1] = atof(arg[6 + ntypes + i]); // construct cutsq double cut; cutmax = 0.0; - memory->create(cutsq,ntypes+1,ntypes+1,"sna/grid:cutsq"); - for(int i = 1; i <= ntypes; i++) { - cut = 2.0*radelem[i]*rcutfac; + memory->create(cutsq, ntypes + 1, ntypes + 1, "sna/grid:cutsq"); + for (int i = 1; i <= ntypes; i++) { + cut = 2.0 * radelem[i] * rcutfac; if (cut > cutmax) cutmax = cut; - cutsq[i][i] = cut*cut; - for(int j = i+1; j <= ntypes; j++) { - cut = (radelem[i]+radelem[j])*rcutfac; - cutsq[i][j] = cutsq[j][i] = cut*cut; + cutsq[i][i] = cut * cut; + for (int j = i + 1; j <= ntypes; j++) { + cut = (radelem[i] + radelem[j]) * rcutfac; + cutsq[i][j] = cutsq[j][i] = cut * cut; } } @@ -103,90 +100,81 @@ ComputeSNAGrid::ComputeSNAGrid(LAMMPS *lmp, int narg, char **arg) : int iarg = nargmin; while (iarg < narg) { - if (strcmp(arg[iarg],"rmin0") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute sna/grid command"); - rmin0 = atof(arg[iarg+1]); + if (strcmp(arg[iarg], "rmin0") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute sna/grid command"); + rmin0 = atof(arg[iarg + 1]); iarg += 2; - } else if (strcmp(arg[iarg],"switchflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute sna/grid command"); - switchflag = atoi(arg[iarg+1]); + } else if (strcmp(arg[iarg], "switchflag") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute sna/grid command"); + switchflag = atoi(arg[iarg + 1]); iarg += 2; - } else if (strcmp(arg[iarg],"bzeroflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute sna/grid command"); - bzeroflag = atoi(arg[iarg+1]); + } else if (strcmp(arg[iarg], "bzeroflag") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute sna/grid command"); + bzeroflag = atoi(arg[iarg + 1]); iarg += 2; - } else if (strcmp(arg[iarg],"quadraticflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute sna/grid command"); - quadraticflag = atoi(arg[iarg+1]); + } else if (strcmp(arg[iarg], "quadraticflag") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute sna/grid command"); + quadraticflag = atoi(arg[iarg + 1]); iarg += 2; - } else if (strcmp(arg[iarg],"chem") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute sna/grid command"); + } else if (strcmp(arg[iarg], "chem") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute sna/grid command"); chemflag = 1; - memory->create(map,ntypes+1,"compute_sna_grid:map"); - nelements = utils::inumeric(FLERR,arg[iarg+1],false,lmp); + memory->create(map, ntypes + 1, "compute_sna_grid:map"); + nelements = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); for (int i = 0; i < ntypes; i++) { - int jelem = utils::inumeric(FLERR,arg[iarg+2+i],false,lmp); - if (jelem < 0 || jelem >= nelements) - error->all(FLERR,"Illegal compute sna/grid command"); - map[i+1] = jelem; + int jelem = utils::inumeric(FLERR, arg[iarg + 2 + i], false, lmp); + if (jelem < 0 || jelem >= nelements) error->all(FLERR, "Illegal compute sna/grid command"); + map[i + 1] = jelem; } - iarg += 2+ntypes; - } else if (strcmp(arg[iarg],"bnormflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute sna/grid command"); - bnormflag = atoi(arg[iarg+1]); + iarg += 2 + ntypes; + } else if (strcmp(arg[iarg], "bnormflag") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute sna/grid command"); + bnormflag = atoi(arg[iarg + 1]); iarg += 2; - } else if (strcmp(arg[iarg],"wselfallflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute sna/grid command"); - wselfallflag = atoi(arg[iarg+1]); + } else if (strcmp(arg[iarg], "wselfallflag") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute sna/grid command"); + wselfallflag = atoi(arg[iarg + 1]); iarg += 2; - } else if (strcmp(arg[iarg],"switchinnerflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute sna/grid command"); - switchinnerflag = atoi(arg[iarg+1]); + } else if (strcmp(arg[iarg], "switchinnerflag") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute sna/grid command"); + switchinnerflag = atoi(arg[iarg + 1]); iarg += 2; - } else if (strcmp(arg[iarg],"sinner") == 0) { + } else if (strcmp(arg[iarg], "sinner") == 0) { iarg++; - if (iarg+ntypes > narg) - error->all(FLERR,"Illegal compute sna/grid command"); - memory->create(sinnerelem,ntypes+1,"snap:sinnerelem"); + if (iarg + ntypes > narg) error->all(FLERR, "Illegal compute sna/grid command"); + memory->create(sinnerelem, ntypes + 1, "snap:sinnerelem"); for (int i = 0; i < ntypes; i++) - sinnerelem[i+1] = utils::numeric(FLERR,arg[iarg+i],false,lmp); + sinnerelem[i + 1] = utils::numeric(FLERR, arg[iarg + i], false, lmp); sinnerflag = 1; iarg += ntypes; - } else if (strcmp(arg[iarg],"dinner") == 0) { + } else if (strcmp(arg[iarg], "dinner") == 0) { iarg++; - if (iarg+ntypes > narg) - error->all(FLERR,"Illegal compute sna/grid command"); - memory->create(dinnerelem,ntypes+1,"snap:dinnerelem"); + if (iarg + ntypes > narg) error->all(FLERR, "Illegal compute sna/grid command"); + memory->create(dinnerelem, ntypes + 1, "snap:dinnerelem"); for (int i = 0; i < ntypes; i++) - dinnerelem[i+1] = utils::numeric(FLERR,arg[iarg+i],false,lmp); + dinnerelem[i + 1] = utils::numeric(FLERR, arg[iarg + i], false, lmp); dinnerflag = 1; iarg += ntypes; - } else error->all(FLERR,"Illegal compute sna/grid command"); - + } else + error->all(FLERR, "Illegal compute sna/grid command"); } if (switchinnerflag && !(sinnerflag && dinnerflag)) - error->all(FLERR,"Illegal compute sna/grid command: switchinnerflag = 1, missing sinner/dinner keyword"); + error->all( + FLERR, + "Illegal compute sna/grid command: switchinnerflag = 1, missing sinner/dinner keyword"); if (!switchinnerflag && (sinnerflag || dinnerflag)) - error->all(FLERR,"Illegal compute sna/grid command: switchinnerflag = 0, unexpected sinner/dinner keyword"); + error->all( + FLERR, + "Illegal compute sna/grid command: switchinnerflag = 0, unexpected sinner/dinner keyword"); - snaptr = new SNA(lmp, rfac0, twojmax, - rmin0, switchflag, bzeroflag, - chemflag, bnormflag, wselfallflag, - nelements, switchinnerflag); + snaptr = new SNA(lmp, rfac0, twojmax, rmin0, switchflag, bzeroflag, chemflag, bnormflag, + wselfallflag, nelements, switchinnerflag); ncoeff = snaptr->ncoeff; nvalues = ncoeff; - if (quadraticflag) nvalues += (ncoeff*(ncoeff+1))/2; + if (quadraticflag) nvalues += (ncoeff * (ncoeff + 1)) / 2; size_array_cols = size_array_cols_base + nvalues; array_flag = 1; } @@ -209,9 +197,8 @@ void ComputeSNAGrid::init() { int count = 0; for (int i = 0; i < modify->ncompute; i++) - if (strcmp(modify->compute[i]->style,"sna/grid") == 0) count++; - if (count > 1 && comm->me == 0) - error->warning(FLERR,"More than one compute sna/grid"); + if (strcmp(modify->compute[i]->style, "sna/grid") == 0) count++; + if (count > 1 && comm->me == 0) error->warning(FLERR, "More than one compute sna/grid"); snaptr->init(); } @@ -230,9 +217,9 @@ void ComputeSNAGrid::compute_array() // compute sna for each gridpoint - double** const x = atom->x; - const int* const mask = atom->mask; - int * const type = atom->type; + double **const x = atom->x; + const int *const mask = atom->mask; + int *const type = atom->type; const int ntotal = atom->nlocal + atom->nghost; // insure rij, inside, and typej are of size jnum @@ -243,7 +230,7 @@ void ComputeSNAGrid::compute_array() for (int iy = nylo; iy <= nyhi; iy++) for (int ix = nxlo; ix <= nxhi; ix++) { double xgrid[3]; - const int igrid = iz*(nx*ny) + iy*nx + ix; + const int igrid = iz * (nx * ny) + iy * nx + ix; grid2x(igrid, xgrid); const double xtmp = xgrid[0]; const double ytmp = xgrid[1]; @@ -253,8 +240,7 @@ void ComputeSNAGrid::compute_array() const int itype = 1; int ielem = 0; - if (chemflag) - ielem = map[itype]; + if (chemflag) ielem = map[itype]; // rij[][3] = displacements between atom I and those neighbors // inside = indices of neighbors of I within cutoff @@ -270,11 +256,10 @@ void ComputeSNAGrid::compute_array() const double delx = xtmp - x[j][0]; const double dely = ytmp - x[j][1]; const double delz = ztmp - x[j][2]; - const double rsq = delx*delx + dely*dely + delz*delz; + const double rsq = delx * delx + dely * dely + delz * delz; int jtype = type[j]; int jelem = 0; - if (chemflag) - jelem = map[jtype]; + if (chemflag) jelem = map[jtype]; if (rsq < cutsq[jtype][jtype] && rsq > 1e-20) { snaptr->rij[ninside][0] = delx; @@ -282,7 +267,7 @@ void ComputeSNAGrid::compute_array() snaptr->rij[ninside][2] = delz; snaptr->inside[ninside] = j; snaptr->wj[ninside] = wjelem[jtype]; - snaptr->rcutij[ninside] = 2.0*radelem[jtype]*rcutfac; + snaptr->rcutij[ninside] = 2.0 * radelem[jtype] * rcutfac; if (switchinnerflag) { snaptr->sinnerij[ninside] = sinnerelem[jelem]; snaptr->dinnerij[ninside] = dinnerelem[jelem]; @@ -299,7 +284,7 @@ void ComputeSNAGrid::compute_array() // linear contributions for (int icoeff = 0; icoeff < ncoeff; icoeff++) - gridlocal[size_array_cols_base+icoeff][iz][iy][ix] = snaptr->blist[icoeff]; + gridlocal[size_array_cols_base + icoeff][iz][iy][ix] = snaptr->blist[icoeff]; // quadratic contributions @@ -307,28 +292,28 @@ void ComputeSNAGrid::compute_array() int ncount = ncoeff; for (int icoeff = 0; icoeff < ncoeff; icoeff++) { double bveci = snaptr->blist[icoeff]; - gridlocal[size_array_cols_base+ncount++][iz][iy][ix] = 0.5*bveci*bveci; - for (int jcoeff = icoeff+1; jcoeff < ncoeff; jcoeff++) - gridlocal[size_array_cols_base+ncount++][iz][iy][ix] = bveci*snaptr->blist[jcoeff]; + gridlocal[size_array_cols_base + ncount++][iz][iy][ix] = 0.5 * bveci * bveci; + for (int jcoeff = icoeff + 1; jcoeff < ncoeff; jcoeff++) + gridlocal[size_array_cols_base + ncount++][iz][iy][ix] = + bveci * snaptr->blist[jcoeff]; } } } - memset(&grid[0][0],0,size_array_rows*size_array_cols*sizeof(double)); + memset(&grid[0][0], 0, size_array_rows * size_array_cols * sizeof(double)); for (int iz = nzlo; iz <= nzhi; iz++) for (int iy = nylo; iy <= nyhi; iy++) for (int ix = nxlo; ix <= nxhi; ix++) { - const int igrid = iz*(nx*ny) + iy*nx + ix; + const int igrid = iz * (nx * ny) + iy * nx + ix; for (int j = 0; j < nvalues; j++) grid[igrid][size_array_cols_base + j] = gridlocal[size_array_cols_base + j][iz][iy][ix]; } - MPI_Allreduce(&grid[0][0],&gridall[0][0],size_array_rows*size_array_cols,MPI_DOUBLE,MPI_SUM,world); + MPI_Allreduce(&grid[0][0], &gridall[0][0], size_array_rows * size_array_cols, MPI_DOUBLE, MPI_SUM, + world); assign_coords_all(); - } - /* ---------------------------------------------------------------------- memory usage ------------------------------------------------------------------------- */ @@ -336,9 +321,8 @@ void ComputeSNAGrid::compute_array() double ComputeSNAGrid::memory_usage() { double nbytes = snaptr->memory_usage(); // SNA object - int n = atom->ntypes+1; - nbytes += (double)n*sizeof(int); // map + int n = atom->ntypes + 1; + nbytes += (double) n * sizeof(int); // map return nbytes; } - diff --git a/src/ML-SNAP/compute_sna_grid.h b/src/ML-SNAP/compute_sna_grid.h index 750f779a00..7eef027ef7 100644 --- a/src/ML-SNAP/compute_sna_grid.h +++ b/src/ML-SNAP/compute_sna_grid.h @@ -50,7 +50,7 @@ class ComputeSNAGrid : public ComputeGrid { int quadraticflag; }; -} +} // namespace LAMMPS_NS #endif #endif diff --git a/src/ML-SNAP/compute_sna_grid_local.cpp b/src/ML-SNAP/compute_sna_grid_local.cpp index 614880043c..7359acacbf 100644 --- a/src/ML-SNAP/compute_sna_grid_local.cpp +++ b/src/ML-SNAP/compute_sna_grid_local.cpp @@ -11,22 +11,22 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ -#include "compute_grid_local.h" #include "compute_sna_grid_local.h" -#include "sna.h" + #include "atom.h" -#include "update.h" +#include "comm.h" +#include "domain.h" +#include "error.h" +#include "force.h" +#include "memory.h" #include "modify.h" -#include "neighbor.h" #include "neigh_list.h" #include "neigh_request.h" -#include "force.h" +#include "neighbor.h" #include "pair.h" -#include "domain.h" -#include "comm.h" -#include "memory.h" -#include "error.h" +#include "sna.h" #include "tokenizer.h" +#include "update.h" #include #include @@ -34,8 +34,7 @@ using namespace LAMMPS_NS; ComputeSNAGridLocal::ComputeSNAGridLocal(LAMMPS *lmp, int narg, char **arg) : - ComputeGridLocal(lmp, narg, arg), cutsq(nullptr), - radelem(nullptr), wjelem(nullptr) + ComputeGridLocal(lmp, narg, arg), cutsq(nullptr), radelem(nullptr), wjelem(nullptr) { double rfac0, rmin0; int twojmax, switchflag, bzeroflag, bnormflag, wselfallflag; @@ -48,9 +47,9 @@ ComputeSNAGridLocal::ComputeSNAGridLocal(LAMMPS *lmp, int narg, char **arg) : narg -= nargbase; int ntypes = atom->ntypes; - int nargmin = 6+2*ntypes; + int nargmin = 6 + 2 * ntypes; - if (narg < nargmin) error->all(FLERR,"Illegal compute sna/grid/local command"); + if (narg < nargmin) error->all(FLERR, "Illegal compute sna/grid/local command"); // default values @@ -71,30 +70,29 @@ ComputeSNAGridLocal::ComputeSNAGridLocal(LAMMPS *lmp, int narg, char **arg) : // process required arguments - memory->create(radelem,ntypes+1,"sna/grid/local:radelem"); // offset by 1 to match up with types - memory->create(wjelem,ntypes+1,"sna/grid/local:wjelem"); + memory->create(radelem, ntypes + 1, + "sna/grid/local:radelem"); // offset by 1 to match up with types + memory->create(wjelem, ntypes + 1, "sna/grid/local:wjelem"); rcutfac = atof(arg[3]); rfac0 = atof(arg[4]); twojmax = atoi(arg[5]); - for(int i = 0; i < ntypes; i++) - radelem[i+1] = atof(arg[6+i]); - for(int i = 0; i < ntypes; i++) - wjelem[i+1] = atof(arg[6+ntypes+i]); + for (int i = 0; i < ntypes; i++) radelem[i + 1] = atof(arg[6 + i]); + for (int i = 0; i < ntypes; i++) wjelem[i + 1] = atof(arg[6 + ntypes + i]); // construct cutsq double cut; cutmax = 0.0; - memory->create(cutsq,ntypes+1,ntypes+1,"sna/grid/local:cutsq"); - for(int i = 1; i <= ntypes; i++) { - cut = 2.0*radelem[i]*rcutfac; + memory->create(cutsq, ntypes + 1, ntypes + 1, "sna/grid/local:cutsq"); + for (int i = 1; i <= ntypes; i++) { + cut = 2.0 * radelem[i] * rcutfac; if (cut > cutmax) cutmax = cut; - cutsq[i][i] = cut*cut; - for(int j = i+1; j <= ntypes; j++) { - cut = (radelem[i]+radelem[j])*rcutfac; - cutsq[i][j] = cutsq[j][i] = cut*cut; + cutsq[i][i] = cut * cut; + for (int j = i + 1; j <= ntypes; j++) { + cut = (radelem[i] + radelem[j]) * rcutfac; + cutsq[i][j] = cutsq[j][i] = cut * cut; } } @@ -103,90 +101,82 @@ ComputeSNAGridLocal::ComputeSNAGridLocal(LAMMPS *lmp, int narg, char **arg) : int iarg = nargmin; while (iarg < narg) { - if (strcmp(arg[iarg],"rmin0") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute sna/grid/local command"); - rmin0 = atof(arg[iarg+1]); + if (strcmp(arg[iarg], "rmin0") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute sna/grid/local command"); + rmin0 = atof(arg[iarg + 1]); iarg += 2; - } else if (strcmp(arg[iarg],"switchflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute sna/grid/local command"); - switchflag = atoi(arg[iarg+1]); + } else if (strcmp(arg[iarg], "switchflag") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute sna/grid/local command"); + switchflag = atoi(arg[iarg + 1]); iarg += 2; - } else if (strcmp(arg[iarg],"bzeroflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute sna/grid/local command"); - bzeroflag = atoi(arg[iarg+1]); + } else if (strcmp(arg[iarg], "bzeroflag") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute sna/grid/local command"); + bzeroflag = atoi(arg[iarg + 1]); iarg += 2; - } else if (strcmp(arg[iarg],"quadraticflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute sna/grid/local command"); - quadraticflag = atoi(arg[iarg+1]); + } else if (strcmp(arg[iarg], "quadraticflag") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute sna/grid/local command"); + quadraticflag = atoi(arg[iarg + 1]); iarg += 2; - } else if (strcmp(arg[iarg],"chem") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute sna/grid/local command"); + } else if (strcmp(arg[iarg], "chem") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute sna/grid/local command"); chemflag = 1; - memory->create(map,ntypes+1,"compute_sna_grid_local:map"); - nelements = utils::inumeric(FLERR,arg[iarg+1],false,lmp); + memory->create(map, ntypes + 1, "compute_sna_grid_local:map"); + nelements = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); for (int i = 0; i < ntypes; i++) { - int jelem = utils::inumeric(FLERR,arg[iarg+2+i],false,lmp); + int jelem = utils::inumeric(FLERR, arg[iarg + 2 + i], false, lmp); if (jelem < 0 || jelem >= nelements) - error->all(FLERR,"Illegal compute sna/grid/local command"); - map[i+1] = jelem; + error->all(FLERR, "Illegal compute sna/grid/local command"); + map[i + 1] = jelem; } - iarg += 2+ntypes; - } else if (strcmp(arg[iarg],"bnormflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute sna/grid/local command"); - bnormflag = atoi(arg[iarg+1]); + iarg += 2 + ntypes; + } else if (strcmp(arg[iarg], "bnormflag") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute sna/grid/local command"); + bnormflag = atoi(arg[iarg + 1]); iarg += 2; - } else if (strcmp(arg[iarg],"wselfallflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute sna/grid/local command"); - wselfallflag = atoi(arg[iarg+1]); + } else if (strcmp(arg[iarg], "wselfallflag") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute sna/grid/local command"); + wselfallflag = atoi(arg[iarg + 1]); iarg += 2; - } else if (strcmp(arg[iarg],"switchinnerflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute sna/grid/local command"); - switchinnerflag = atoi(arg[iarg+1]); + } else if (strcmp(arg[iarg], "switchinnerflag") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute sna/grid/local command"); + switchinnerflag = atoi(arg[iarg + 1]); iarg += 2; - } else if (strcmp(arg[iarg],"sinner") == 0) { + } else if (strcmp(arg[iarg], "sinner") == 0) { iarg++; - if (iarg+ntypes > narg) - error->all(FLERR,"Illegal compute sna/grid/local command"); - memory->create(sinnerelem,ntypes+1,"snap:sinnerelem"); + if (iarg + ntypes > narg) error->all(FLERR, "Illegal compute sna/grid/local command"); + memory->create(sinnerelem, ntypes + 1, "snap:sinnerelem"); for (int i = 0; i < ntypes; i++) - sinnerelem[i+1] = utils::numeric(FLERR,arg[iarg+i],false,lmp); + sinnerelem[i + 1] = utils::numeric(FLERR, arg[iarg + i], false, lmp); sinnerflag = 1; iarg += ntypes; - } else if (strcmp(arg[iarg],"dinner") == 0) { + } else if (strcmp(arg[iarg], "dinner") == 0) { iarg++; - if (iarg+ntypes > narg) - error->all(FLERR,"Illegal compute sna/grid/local command"); - memory->create(dinnerelem,ntypes+1,"snap:dinnerelem"); + if (iarg + ntypes > narg) error->all(FLERR, "Illegal compute sna/grid/local command"); + memory->create(dinnerelem, ntypes + 1, "snap:dinnerelem"); for (int i = 0; i < ntypes; i++) - dinnerelem[i+1] = utils::numeric(FLERR,arg[iarg+i],false,lmp); + dinnerelem[i + 1] = utils::numeric(FLERR, arg[iarg + i], false, lmp); dinnerflag = 1; iarg += ntypes; - } else error->all(FLERR,"Illegal compute sna/grid/local command"); - + } else + error->all(FLERR, "Illegal compute sna/grid/local command"); } if (switchinnerflag && !(sinnerflag && dinnerflag)) - error->all(FLERR,"Illegal compute sna/grid/local command: switchinnerflag = 1, missing sinner/dinner keyword"); + error->all(FLERR, + "Illegal compute sna/grid/local command: switchinnerflag = 1, missing sinner/dinner " + "keyword"); if (!switchinnerflag && (sinnerflag || dinnerflag)) - error->all(FLERR,"Illegal compute sna/grid/local command: switchinnerflag = 0, unexpected sinner/dinner keyword"); + error->all(FLERR, + "Illegal compute sna/grid/local command: switchinnerflag = 0, unexpected " + "sinner/dinner keyword"); - snaptr = new SNA(lmp, rfac0, twojmax, - rmin0, switchflag, bzeroflag, - chemflag, bnormflag, wselfallflag, - nelements, switchinnerflag); + snaptr = new SNA(lmp, rfac0, twojmax, rmin0, switchflag, bzeroflag, chemflag, bnormflag, + wselfallflag, nelements, switchinnerflag); ncoeff = snaptr->ncoeff; nvalues = ncoeff; - if (quadraticflag) nvalues += (ncoeff*(ncoeff+1))/2; + if (quadraticflag) nvalues += (ncoeff * (ncoeff + 1)) / 2; size_local_cols = size_local_cols_base + nvalues; } @@ -208,9 +198,8 @@ void ComputeSNAGridLocal::init() { int count = 0; for (int i = 0; i < modify->ncompute; i++) - if (strcmp(modify->compute[i]->style,"sna/grid/local") == 0) count++; - if (count > 1 && comm->me == 0) - error->warning(FLERR,"More than one compute sna/grid/local"); + if (strcmp(modify->compute[i]->style, "sna/grid/local") == 0) count++; + if (count > 1 && comm->me == 0) error->warning(FLERR, "More than one compute sna/grid/local"); snaptr->init(); } @@ -229,9 +218,9 @@ void ComputeSNAGridLocal::compute_local() // compute sna for each gridpoint - double** const x = atom->x; - const int* const mask = atom->mask; - int * const type = atom->type; + double **const x = atom->x; + const int *const mask = atom->mask; + int *const type = atom->type; const int ntotal = atom->nlocal + atom->nghost; // insure rij, inside, and typej are of size jnum @@ -252,8 +241,7 @@ void ComputeSNAGridLocal::compute_local() const int itype = 1; int ielem = 0; - if (chemflag) - ielem = map[itype]; + if (chemflag) ielem = map[itype]; // rij[][3] = displacements between atom I and those neighbors // inside = indices of neighbors of I within cutoff @@ -269,23 +257,23 @@ void ComputeSNAGridLocal::compute_local() const double delx = xtmp - x[j][0]; const double dely = ytmp - x[j][1]; const double delz = ztmp - x[j][2]; - const double rsq = delx*delx + dely*dely + delz*delz; + const double rsq = delx * delx + dely * dely + delz * delz; int jtype = type[j]; int jelem = 0; - if (chemflag) - jelem = map[jtype]; + if (chemflag) jelem = map[jtype]; if (rsq < cutsq[jtype][jtype] && rsq > 1e-20) { snaptr->rij[ninside][0] = delx; snaptr->rij[ninside][1] = dely; snaptr->rij[ninside][2] = delz; snaptr->inside[ninside] = j; snaptr->wj[ninside] = wjelem[jtype]; - snaptr->rcutij[ninside] = 2.0*radelem[jtype]*rcutfac; + snaptr->rcutij[ninside] = 2.0 * radelem[jtype] * rcutfac; if (switchinnerflag) { snaptr->sinnerij[ninside] = sinnerelem[jelem]; snaptr->dinnerij[ninside] = dinnerelem[jelem]; } - if (chemflag) snaptr->element[ninside] = jelem; // element index for multi-element snap + if (chemflag) + snaptr->element[ninside] = jelem; // element index for multi-element snap ninside++; } } @@ -297,7 +285,7 @@ void ComputeSNAGridLocal::compute_local() // linear contributions for (int icoeff = 0; icoeff < ncoeff; icoeff++) - alocal[igrid][size_local_cols_base+icoeff] = snaptr->blist[icoeff]; + alocal[igrid][size_local_cols_base + icoeff] = snaptr->blist[icoeff]; // quadratic contributions @@ -305,17 +293,15 @@ void ComputeSNAGridLocal::compute_local() int ncount = ncoeff; for (int icoeff = 0; icoeff < ncoeff; icoeff++) { double bveci = snaptr->blist[icoeff]; - alocal[igrid][size_local_cols_base+ncount++] = 0.5*bveci*bveci; - for (int jcoeff = icoeff+1; jcoeff < ncoeff; jcoeff++) - alocal[igrid][size_local_cols_base+ncount++] = - bveci*snaptr->blist[jcoeff]; + alocal[igrid][size_local_cols_base + ncount++] = 0.5 * bveci * bveci; + for (int jcoeff = icoeff + 1; jcoeff < ncoeff; jcoeff++) + alocal[igrid][size_local_cols_base + ncount++] = bveci * snaptr->blist[jcoeff]; } } igrid++; } } - /* ---------------------------------------------------------------------- memory usage ------------------------------------------------------------------------- */ @@ -323,9 +309,8 @@ void ComputeSNAGridLocal::compute_local() double ComputeSNAGridLocal::memory_usage() { double nbytes = snaptr->memory_usage(); // SNA object - int n = atom->ntypes+1; - nbytes += (double)n*sizeof(int); // map + int n = atom->ntypes + 1; + nbytes += (double) n * sizeof(int); // map return nbytes; } - diff --git a/src/ML-SNAP/compute_sna_grid_local.h b/src/ML-SNAP/compute_sna_grid_local.h index c7678d049e..760d0de8cc 100644 --- a/src/ML-SNAP/compute_sna_grid_local.h +++ b/src/ML-SNAP/compute_sna_grid_local.h @@ -50,7 +50,7 @@ class ComputeSNAGridLocal : public ComputeGridLocal { int quadraticflag; }; -} +} // namespace LAMMPS_NS #endif #endif diff --git a/src/compute_grid.cpp b/src/compute_grid.cpp index 60c9987cbc..0a8ba5a697 100644 --- a/src/compute_grid.cpp +++ b/src/compute_grid.cpp @@ -12,25 +12,26 @@ ------------------------------------------------------------------------- */ #include "compute_grid.h" -#include -#include + #include "atom.h" -#include "update.h" -#include "modify.h" +#include "comm.h" #include "domain.h" +#include "error.h" #include "force.h" #include "memory.h" -#include "error.h" -#include "comm.h" +#include "modify.h" +#include "update.h" + +#include using namespace LAMMPS_NS; /* ---------------------------------------------------------------------- */ ComputeGrid::ComputeGrid(LAMMPS *lmp, int narg, char **arg) : - Compute(lmp, narg, arg), grid(nullptr), gridall(nullptr), gridlocal(nullptr) + Compute(lmp, narg, arg), grid(nullptr), gridall(nullptr), gridlocal(nullptr) { - if (narg < 6) error->all(FLERR,"Illegal compute grid command"); + if (narg < 6) error->all(FLERR, "Illegal compute grid command"); array_flag = 1; size_array_cols = 0; @@ -39,19 +40,19 @@ ComputeGrid::ComputeGrid(LAMMPS *lmp, int narg, char **arg) : int iarg0 = 3; int iarg = iarg0; - if (strcmp(arg[iarg],"grid") == 0) { - if (iarg+4 > narg) error->all(FLERR,"Illegal compute grid command"); - nx = utils::inumeric(FLERR,arg[iarg+1],false,lmp); - ny = utils::inumeric(FLERR,arg[iarg+2],false,lmp); - nz = utils::inumeric(FLERR,arg[iarg+3],false,lmp); - if (nx <= 0 || ny <= 0 || nz <= 0) - error->all(FLERR,"All grid dimensions must be positive"); + if (strcmp(arg[iarg], "grid") == 0) { + if (iarg + 4 > narg) error->all(FLERR, "Illegal compute grid command"); + nx = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); + ny = utils::inumeric(FLERR, arg[iarg + 2], false, lmp); + nz = utils::inumeric(FLERR, arg[iarg + 3], false, lmp); + if (nx <= 0 || ny <= 0 || nz <= 0) error->all(FLERR, "All grid dimensions must be positive"); iarg += 4; - } else error->all(FLERR,"Illegal compute grid command"); + } else + error->all(FLERR, "Illegal compute grid command"); nargbase = iarg - iarg0; - size_array_rows = nx*ny*nz; + size_array_rows = nx * ny * nz; size_array_cols_base = 3; gridlocal_allocated = 0; } @@ -65,9 +66,7 @@ ComputeGrid::~ComputeGrid() /* ---------------------------------------------------------------------- */ -void ComputeGrid::init() -{ -} +void ComputeGrid::init() {} /* ---------------------------------------------------------------------- */ @@ -85,18 +84,17 @@ void ComputeGrid::setup() void ComputeGrid::grid2x(int igrid, double *x) { - int iz = igrid / (nx*ny); - igrid -= iz * (nx*ny); + int iz = igrid / (nx * ny); + igrid -= iz * (nx * ny); int iy = igrid / nx; igrid -= iy * nx; int ix = igrid; - x[0] = ix*delx; - x[1] = iy*dely; - x[2] = iz*delz; + x[0] = ix * delx; + x[1] = iy * dely; + x[2] = iz * delz; if (triclinic) domain->lamda2x(x, x); - } /* ---------------------------------------------------------------------- @@ -107,7 +105,7 @@ void ComputeGrid::assign_coords_all() { double x[3]; for (int igrid = 0; igrid < size_array_rows; igrid++) { - grid2x(igrid,x); + grid2x(igrid, x); gridall[igrid][0] = x[0]; gridall[igrid][1] = x[1]; gridall[igrid][2] = x[2]; @@ -122,18 +120,17 @@ void ComputeGrid::allocate() { // allocate arrays - printf("In allocate() %d %d \n", size_array_rows,size_array_cols); - memory->create(grid,size_array_rows,size_array_cols,"grid:grid"); - memory->create(gridall,size_array_rows,size_array_cols,"grid:gridall"); + printf("In allocate() %d %d \n", size_array_rows, size_array_cols); + memory->create(grid, size_array_rows, size_array_cols, "grid:grid"); + memory->create(gridall, size_array_rows, size_array_cols, "grid:gridall"); if (nxlo <= nxhi && nylo <= nyhi && nzlo <= nzhi) { gridlocal_allocated = 1; - memory->create4d_offset(gridlocal,size_array_cols,nzlo,nzhi,nylo,nyhi, - nxlo,nxhi,"grid:gridlocal"); + memory->create4d_offset(gridlocal, size_array_cols, nzlo, nzhi, nylo, nyhi, nxlo, nxhi, + "grid:gridlocal"); } array = gridall; } - /* ---------------------------------------------------------------------- free arrays ------------------------------------------------------------------------- */ @@ -144,19 +141,18 @@ void ComputeGrid::deallocate() memory->destroy(gridall); if (gridlocal_allocated) { gridlocal_allocated = 0; - memory->destroy4d_offset(gridlocal,nzlo,nylo,nxlo); + memory->destroy4d_offset(gridlocal, nzlo, nylo, nxlo); } array = nullptr; } - /* ---------------------------------------------------------------------- set global grid ------------------------------------------------------------------------- */ void ComputeGrid::set_grid_global() { - // calculate grid layout + // calculate grid layout triclinic = domain->triclinic; @@ -176,13 +172,13 @@ void ComputeGrid::set_grid_global() double yprd = prd[1]; double zprd = prd[2]; - delxinv = nx/xprd; - delyinv = ny/yprd; - delzinv = nz/zprd; + delxinv = nx / xprd; + delyinv = ny / yprd; + delzinv = nz / zprd; - delx = 1.0/delxinv; - dely = 1.0/delyinv; - delz = 1.0/delzinv; + delx = 1.0 / delxinv; + dely = 1.0 / delyinv; + delz = 1.0 / delzinv; } /* ---------------------------------------------------------------------- @@ -202,15 +198,15 @@ void ComputeGrid::set_grid_local() // the 2 equality if tests insure a consistent decision // as to which proc owns it - double xfraclo,xfrachi,yfraclo,yfrachi,zfraclo,zfrachi; + double xfraclo, xfrachi, yfraclo, yfrachi, zfraclo, zfrachi; if (comm->layout != Comm::LAYOUT_TILED) { xfraclo = comm->xsplit[comm->myloc[0]]; - xfrachi = comm->xsplit[comm->myloc[0]+1]; + xfrachi = comm->xsplit[comm->myloc[0] + 1]; yfraclo = comm->ysplit[comm->myloc[1]]; - yfrachi = comm->ysplit[comm->myloc[1]+1]; + yfrachi = comm->ysplit[comm->myloc[1] + 1]; zfraclo = comm->zsplit[comm->myloc[2]]; - zfrachi = comm->zsplit[comm->myloc[2]+1]; + zfrachi = comm->zsplit[comm->myloc[2] + 1]; } else { xfraclo = comm->mysplit[0][0]; xfrachi = comm->mysplit[0][1]; @@ -220,23 +216,22 @@ void ComputeGrid::set_grid_local() zfrachi = comm->mysplit[2][1]; } - nxlo = static_cast (xfraclo * nx); - if (1.0*nxlo != xfraclo*nx) nxlo++; - nxhi = static_cast (xfrachi * nx); - if (1.0*nxhi == xfrachi*nx) nxhi--; + nxlo = static_cast(xfraclo * nx); + if (1.0 * nxlo != xfraclo * nx) nxlo++; + nxhi = static_cast(xfrachi * nx); + if (1.0 * nxhi == xfrachi * nx) nxhi--; - nylo = static_cast (yfraclo * ny); - if (1.0*nylo != yfraclo*ny) nylo++; - nyhi = static_cast (yfrachi * ny); - if (1.0*nyhi == yfrachi*ny) nyhi--; + nylo = static_cast(yfraclo * ny); + if (1.0 * nylo != yfraclo * ny) nylo++; + nyhi = static_cast(yfrachi * ny); + if (1.0 * nyhi == yfrachi * ny) nyhi--; - nzlo = static_cast (zfraclo * nz); - if (1.0*nzlo != zfraclo*nz) nzlo++; - nzhi = static_cast (zfrachi * nz); - if (1.0*nzhi == zfrachi*nz) nzhi--; + nzlo = static_cast(zfraclo * nz); + if (1.0 * nzlo != zfraclo * nz) nzlo++; + nzhi = static_cast(zfrachi * nz); + if (1.0 * nzhi == zfrachi * nz) nzhi--; ngridlocal = (nxhi - nxlo + 1) * (nyhi - nylo + 1) * (nzhi - nzlo + 1); - } /* ---------------------------------------------------------------------- @@ -245,10 +240,8 @@ void ComputeGrid::set_grid_local() double ComputeGrid::memory_usage() { - double nbytes = size_array_rows*size_array_cols * - sizeof(double); // grid - nbytes += size_array_rows*size_array_cols * - sizeof(double); // gridall - nbytes += size_array_cols*ngridlocal*sizeof(double); // gridlocal + double nbytes = size_array_rows * size_array_cols * sizeof(double); // grid + nbytes += size_array_rows * size_array_cols * sizeof(double); // gridall + nbytes += size_array_cols * ngridlocal * sizeof(double); // gridlocal return nbytes; } diff --git a/src/compute_grid.h b/src/compute_grid.h index 4264039cc8..96338a035d 100644 --- a/src/compute_grid.h +++ b/src/compute_grid.h @@ -20,7 +20,6 @@ namespace LAMMPS_NS { class ComputeGrid : public Compute { public: - ComputeGrid(class LAMMPS *, int, char **); ~ComputeGrid() override; void init() override; @@ -30,31 +29,31 @@ class ComputeGrid : public Compute { double memory_usage() override; protected: - int nx, ny, nz; // global grid dimensions - int nxlo, nxhi, nylo, nyhi, nzlo, nzhi; // local grid bounds, inclusive - int ngridlocal; // number of local grid points - int nvalues; // number of values per grid point - double **grid; // global grid - double **gridall; // global grid summed over procs - double ****gridlocal; // local grid - int triclinic; // triclinic flag - double *boxlo, *prd; // box info (units real/ortho or reduced/tri) - double *sublo, *subhi; // subdomain info (units real/ortho or reduced/tri) - double delxinv,delyinv,delzinv; // inverse grid spacing - double delx,dely,delz; // grid spacing - int nargbase; // number of base class args - double cutmax; // largest cutoff distance - int size_array_cols_base; // number of columns used for coords, etc. - int gridlocal_allocated; // shows if gridlocal allocated + int nx, ny, nz; // global grid dimensions + int nxlo, nxhi, nylo, nyhi, nzlo, nzhi; // local grid bounds, inclusive + int ngridlocal; // number of local grid points + int nvalues; // number of values per grid point + double **grid; // global grid + double **gridall; // global grid summed over procs + double ****gridlocal; // local grid + int triclinic; // triclinic flag + double *boxlo, *prd; // box info (units real/ortho or reduced/tri) + double *sublo, *subhi; // subdomain info (units real/ortho or reduced/tri) + double delxinv, delyinv, delzinv; // inverse grid spacing + double delx, dely, delz; // grid spacing + int nargbase; // number of base class args + double cutmax; // largest cutoff distance + int size_array_cols_base; // number of columns used for coords, etc. + int gridlocal_allocated; // shows if gridlocal allocated - void allocate(); // create arrays - void deallocate(); // free arrays - void grid2x(int, double*); // convert grid point to coord - void assign_coords_all(); // assign coords for global grid - void set_grid_global(); // set global grid - void set_grid_local(); // set bounds for local grid + void allocate(); // create arrays + void deallocate(); // free arrays + void grid2x(int, double *); // convert grid point to coord + void assign_coords_all(); // assign coords for global grid + void set_grid_global(); // set global grid + void set_grid_local(); // set bounds for local grid }; -} +} // namespace LAMMPS_NS #endif diff --git a/src/compute_grid_local.cpp b/src/compute_grid_local.cpp index e30d06fe45..5f341680bd 100644 --- a/src/compute_grid_local.cpp +++ b/src/compute_grid_local.cpp @@ -12,29 +12,30 @@ ------------------------------------------------------------------------- */ #include "compute_grid_local.h" -#include -#include + #include "atom.h" -#include "update.h" -#include "modify.h" +#include "comm.h" #include "domain.h" +#include "error.h" #include "force.h" #include "memory.h" -#include "error.h" -#include "comm.h" +#include "modify.h" +#include "update.h" + +#include // For the subdomain test below; grid-points and subdomain boundaries // sometimes differ by minimal amounts (in the order of 2e-17). -#define EPSILON 1.0e-10 +static constexpr double EPSILON = 1.0e-10; using namespace LAMMPS_NS; /* ---------------------------------------------------------------------- */ ComputeGridLocal::ComputeGridLocal(LAMMPS *lmp, int narg, char **arg) : - Compute(lmp, narg, arg), alocal(nullptr) + Compute(lmp, narg, arg), alocal(nullptr) { - if (narg < 6) error->all(FLERR,"Illegal compute grid/local command"); + if (narg < 6) error->all(FLERR, "Illegal compute grid/local command"); local_flag = 1; size_local_cols = 0; @@ -43,15 +44,16 @@ ComputeGridLocal::ComputeGridLocal(LAMMPS *lmp, int narg, char **arg) : int iarg0 = 3; int iarg = iarg0; - if (strcmp(arg[iarg],"grid") == 0) { - if (iarg+4 > narg) error->all(FLERR,"Illegal compute grid/local command"); - nx = utils::inumeric(FLERR,arg[iarg+1],false,lmp); - ny = utils::inumeric(FLERR,arg[iarg+2],false,lmp); - nz = utils::inumeric(FLERR,arg[iarg+3],false,lmp); + if (strcmp(arg[iarg], "grid") == 0) { + if (iarg + 4 > narg) error->all(FLERR, "Illegal compute grid/local command"); + nx = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); + ny = utils::inumeric(FLERR, arg[iarg + 2], false, lmp); + nz = utils::inumeric(FLERR, arg[iarg + 3], false, lmp); if (nx <= 0 || ny <= 0 || nz <= 0) - error->all(FLERR,"All grid/local dimensions must be positive"); + error->all(FLERR, "All grid/local dimensions must be positive"); iarg += 4; - } else error->all(FLERR,"Illegal compute grid/local command"); + } else + error->all(FLERR, "Illegal compute grid/local command"); nargbase = iarg - iarg0; @@ -68,9 +70,7 @@ ComputeGridLocal::~ComputeGridLocal() /* ---------------------------------------------------------------------- */ -void ComputeGridLocal::init() -{ -} +void ComputeGridLocal::init() {} /* ---------------------------------------------------------------------- */ @@ -89,9 +89,9 @@ void ComputeGridLocal::setup() void ComputeGridLocal::grid2x(int ix, int iy, int iz, double *x) { - x[0] = ix*delx; - x[1] = iy*dely; - x[2] = iz*delz; + x[0] = ix * delx; + x[1] = iy * dely; + x[2] = iz * delz; if (triclinic) domain->lamda2x(x, x); } @@ -103,12 +103,11 @@ void ComputeGridLocal::grid2x(int ix, int iy, int iz, double *x) void ComputeGridLocal::grid2lamda(int ix, int iy, int iz, double *x) { - x[0] = ix*delx; - x[1] = iy*dely; - x[2] = iz*delz; + x[0] = ix * delx; + x[1] = iy * dely; + x[2] = iz * delz; } - /* ---------------------------------------------------------------------- create arrays ------------------------------------------------------------------------- */ @@ -141,7 +140,7 @@ void ComputeGridLocal::deallocate() void ComputeGridLocal::set_grid_global() { - // calculate grid layout + // calculate grid layout triclinic = domain->triclinic; @@ -161,13 +160,13 @@ void ComputeGridLocal::set_grid_global() double yprd = prd[1]; double zprd = prd[2]; - delxinv = nx/xprd; - delyinv = ny/yprd; - delzinv = nz/zprd; + delxinv = nx / xprd; + delyinv = ny / yprd; + delzinv = nz / zprd; - delx = 1.0/delxinv; - dely = 1.0/delyinv; - delz = 1.0/delzinv; + delx = 1.0 / delxinv; + dely = 1.0 / delyinv; + delz = 1.0 / delzinv; } /* ---------------------------------------------------------------------- @@ -187,15 +186,15 @@ void ComputeGridLocal::set_grid_local() // the 2 equality if tests insure a consistent decision // as to which proc owns it - double xfraclo,xfrachi,yfraclo,yfrachi,zfraclo,zfrachi; + double xfraclo, xfrachi, yfraclo, yfrachi, zfraclo, zfrachi; if (comm->layout != Comm::LAYOUT_TILED) { xfraclo = comm->xsplit[comm->myloc[0]]; - xfrachi = comm->xsplit[comm->myloc[0]+1]; + xfrachi = comm->xsplit[comm->myloc[0] + 1]; yfraclo = comm->ysplit[comm->myloc[1]]; - yfrachi = comm->ysplit[comm->myloc[1]+1]; + yfrachi = comm->ysplit[comm->myloc[1] + 1]; zfraclo = comm->zsplit[comm->myloc[2]]; - zfrachi = comm->zsplit[comm->myloc[2]+1]; + zfrachi = comm->zsplit[comm->myloc[2] + 1]; } else { xfraclo = comm->mysplit[0][0]; xfrachi = comm->mysplit[0][1]; @@ -205,20 +204,20 @@ void ComputeGridLocal::set_grid_local() zfrachi = comm->mysplit[2][1]; } - nxlo = static_cast (xfraclo * nx); - if (1.0*nxlo != xfraclo*nx) nxlo++; - nxhi = static_cast (xfrachi * nx); - if (1.0*nxhi == xfrachi*nx) nxhi--; + nxlo = static_cast(xfraclo * nx); + if (1.0 * nxlo != xfraclo * nx) nxlo++; + nxhi = static_cast(xfrachi * nx); + if (1.0 * nxhi == xfrachi * nx) nxhi--; - nylo = static_cast (yfraclo * ny); - if (1.0*nylo != yfraclo*ny) nylo++; - nyhi = static_cast (yfrachi * ny); - if (1.0*nyhi == yfrachi*ny) nyhi--; + nylo = static_cast(yfraclo * ny); + if (1.0 * nylo != yfraclo * ny) nylo++; + nyhi = static_cast(yfrachi * ny); + if (1.0 * nyhi == yfrachi * ny) nyhi--; - nzlo = static_cast (zfraclo * nz); - if (1.0*nzlo != zfraclo*nz) nzlo++; - nzhi = static_cast (zfrachi * nz); - if (1.0*nzhi == zfrachi*nz) nzhi--; + nzlo = static_cast(zfraclo * nz); + if (1.0 * nzlo != zfraclo * nz) nzlo++; + nzhi = static_cast(zfrachi * nz); + if (1.0 * nzhi == zfrachi * nz) nzhi--; size_local_rows = (nxhi - nxlo + 1) * (nyhi - nylo + 1) * (nzhi - nzlo + 1); } @@ -248,10 +247,10 @@ void ComputeGridLocal::assign_coords() // ensure gridpoint is not strictly outside subdomain - if ((sublo[0]-xgrid[0]) > EPSILON || (xgrid[0]-subhi[0]) > EPSILON || - (sublo[1]-xgrid[1]) > EPSILON || (xgrid[1]-subhi[1]) > EPSILON || - (sublo[2]-xgrid[2]) > EPSILON || (xgrid[2]-subhi[2]) > EPSILON) - error->one(FLERR,"Invalid gridpoint position in compute grid/local"); + if ((sublo[0] - xgrid[0]) > EPSILON || (xgrid[0] - subhi[0]) > EPSILON || + (sublo[1] - xgrid[1]) > EPSILON || (xgrid[1] - subhi[1]) > EPSILON || + (sublo[2] - xgrid[2]) > EPSILON || (xgrid[2] - subhi[2]) > EPSILON) + error->one(FLERR, "Invalid gridpoint position in compute grid/local"); // convert lamda to x, y, z, after sudomain check @@ -270,6 +269,6 @@ void ComputeGridLocal::assign_coords() double ComputeGridLocal::memory_usage() { - int nbytes = size_local_rows * size_local_cols * sizeof(double); // gridlocal + int nbytes = size_local_rows * size_local_cols * sizeof(double); // gridlocal return nbytes; } diff --git a/src/compute_grid_local.h b/src/compute_grid_local.h index 2989628d79..b34dd2d096 100644 --- a/src/compute_grid_local.h +++ b/src/compute_grid_local.h @@ -20,7 +20,6 @@ namespace LAMMPS_NS { class ComputeGridLocal : public Compute { public: - ComputeGridLocal(class LAMMPS *, int, char **); ~ComputeGridLocal() override; void init() override; @@ -30,29 +29,29 @@ class ComputeGridLocal : public Compute { double memory_usage() override; protected: - int nx, ny, nz; // global grid dimensions - int nxlo, nxhi, nylo, nyhi, nzlo, nzhi; // local grid bounds, inclusive - int nvalues; // number of values per grid point - double **alocal; // pointer to Compute::array_local - int triclinic; // triclinic flag - double *boxlo, *prd; // box info (units real/ortho or reduced/tri) - double *sublo, *subhi; // subdomain info (units real/ortho or reduced/tri) - double delxinv,delyinv,delzinv; // inverse grid spacing - double delx,dely,delz; // grid spacing - int nargbase; // number of base class args - double cutmax; // largest cutoff distance - int size_local_cols_base; // number of columns used for coords, etc. - int gridlocal_allocated; // shows if gridlocal allocated + int nx, ny, nz; // global grid dimensions + int nxlo, nxhi, nylo, nyhi, nzlo, nzhi; // local grid bounds, inclusive + int nvalues; // number of values per grid point + double **alocal; // pointer to Compute::array_local + int triclinic; // triclinic flag + double *boxlo, *prd; // box info (units real/ortho or reduced/tri) + double *sublo, *subhi; // subdomain info (units real/ortho or reduced/tri) + double delxinv, delyinv, delzinv; // inverse grid spacing + double delx, dely, delz; // grid spacing + int nargbase; // number of base class args + double cutmax; // largest cutoff distance + int size_local_cols_base; // number of columns used for coords, etc. + int gridlocal_allocated; // shows if gridlocal allocated - void allocate(); // create arrays - void deallocate(); // free arrays - void grid2x(int, int, int, double*); // convert global indices to coordinates - void grid2lamda(int, int, int, double*); // convert global indices to lamda coordinates - void set_grid_global(); // set global grid - void set_grid_local(); // set bounds for local grid - void assign_coords(); // assign coords for grid + void allocate(); // create arrays + void deallocate(); // free arrays + void grid2x(int, int, int, double *); // convert global indices to coordinates + void grid2lamda(int, int, int, double *); // convert global indices to lamda coordinates + void set_grid_global(); // set global grid + void set_grid_local(); // set bounds for local grid + void assign_coords(); // assign coords for grid }; -} +} // namespace LAMMPS_NS #endif From effae2c01a6473314193ad5180c8d9f6134e0218 Mon Sep 17 00:00:00 2001 From: rohskopf Date: Fri, 17 Jun 2022 12:05:05 -0600 Subject: [PATCH 393/585] Added compute snap descriptor gradient example. --- examples/snap/README.md | 9 + examples/snap/compute_snap_dgrad.py | 130 +++++++++++++ python/examples/in.lj | 25 +++ python/examples/simple.py | 20 +- src/ML-SNAP/compute_snap.cpp | 283 +++++----------------------- 5 files changed, 224 insertions(+), 243 deletions(-) create mode 100644 examples/snap/README.md create mode 100644 examples/snap/compute_snap_dgrad.py create mode 100644 python/examples/in.lj diff --git a/examples/snap/README.md b/examples/snap/README.md new file mode 100644 index 0000000000..7c34fe7021 --- /dev/null +++ b/examples/snap/README.md @@ -0,0 +1,9 @@ +See `compute_snap_dgrad.py` for a test that compares the dBi/dRj from compute snap (`dbirjflag=1`) to the sum of dBi/dRj from usual compute snap (`dbirjflag=0`). + +The format of the global array from `dbirjflag=1` is as follows. + +The first N rows belong to bispectrum components for each atom, if we use `bikflag=1`. The first `K` columns correspond to each bispectrum coefficient. The final 3 columns contain reference force components for each atom. + +The rows after the first N rows contain dBi/dRj values for all pairs. These values are arranged in row chunks for each atom `j`, where all the rows in a chunk are associated with the neighbors `i` of `j`, as well as the self-terms where `i=j`. So for atom `j`, the number of rows is equal to the number of atoms within the SNAP cutoff, plus 1 for the `i=j` terms, times 3 for each Cartesian component. The total number of dBi/dRj rows is therefore equal to `N*(Nneigh+1)*3`, and `Nneigh` may be different for each atom. To facilitate with determining which row belong to which atom pair `ij`, the last 3 columns contain indices; the 3rd to last column contains global indices of atoms `i` (the neighbors), the 2nd to last column contains global indices of atoms `j`, and the last column contains an index 0,1,2 for the Cartesian component. Like the `bik` rows, the first `K` columns correspond to each bispectrum coefficient. + +Finally, the first column of the last row contains the reference energy. diff --git a/examples/snap/compute_snap_dgrad.py b/examples/snap/compute_snap_dgrad.py new file mode 100644 index 0000000000..dc06ae1576 --- /dev/null +++ b/examples/snap/compute_snap_dgrad.py @@ -0,0 +1,130 @@ +""" +compute_snap_dgrad.py +Purpose: Demonstrate extraction of descriptor gradient (dB/dR) array from compute snap. + Show that dBi/dRj components summed over neighbors i yields same output as regular compute snap with dbirjflag=0. + This shows that the dBi/dRj components extracted with dbirjflag=1 are correct. +Serial syntax: + python compute_snap_dgrad.py +Parallel syntax: + mpirun -np 2 python compute_snap_dgrad.py +""" + +from __future__ import print_function +import sys +import ctypes +import numpy as np + +# uncomment this if running in parallel via mpi4py +#me = 0 +#from mpi4py import MPI +#me = MPI.COMM_WORLD.Get_rank() +#nprocs = MPI.COMM_WORLD.Get_size() + +from lammps import lammps, LMP_TYPE_ARRAY, LMP_STYLE_GLOBAL +cmds = ["-screen", "none", "-log", "none"] +lmp = lammps(cmdargs=cmds) + +def run_lammps(dbirjflag): + lmp.command("clear") + lmp.command("units metal") + lmp.command("boundary p p p") + lmp.command("atom_modify map hash") + lmp.command(f"lattice bcc {latparam}") + lmp.command(f"region box block 0 {nx} 0 {ny} 0 {nz}") + lmp.command(f"create_box {ntypes} box") + lmp.command(f"create_atoms {ntypes} box") + lmp.command("mass * 180.88") + lmp.command("displace_atoms all random 0.01 0.01 0.01 123456") + # Pair style + snap_options=f'{rcutfac} {rfac0} {twojmax} {radelem1} {radelem2} {wj1} {wj2} rmin0 {rmin0} quadraticflag {quadratic} bzeroflag {bzero} switchflag {switch} bikflag {bikflag} dbirjflag {dbirjflag}' + lmp.command(f"pair_style zero {rcutfac}") + lmp.command(f"pair_coeff * *") + lmp.command(f"pair_style zbl {zblcutinner} {zblcutouter}") + lmp.command(f"pair_coeff * * {zblz} {zblz}") + # set up compute snap generating global array + lmp.command(f"compute snap all snap {snap_options}") + # Run + lmp.command(f"thermo 100") + lmp.command(f"run {nsteps}") + +# Declare simulation/structure variables +nsteps=0 +nrep=2 +latparam=2.0 +ntypes=2 +nx=nrep +ny=nrep +nz=nrep + +# Declare compute snap variables +twojmax=8 +m = (twojmax/2)+1 +rcutfac=1.0 +rfac0=0.99363 +rmin0=0 +radelem1=2.3 +radelem2=2.0 +wj1=1.0 +wj2=0.96 +quadratic=0 +bzero=0 +switch=0 +bikflag=1 +dbirjflag=1 + +# Declare reference potential variables +zblcutinner=4.0 +zblcutouter=4.8 +zblz=73 + +# Number of descriptors +if (twojmax % 2 == 0): + nd = int(m*(m+1)*(2*m+1)/6) +else: + nd = int(m*(m+1)*(m+2)/3) +print(f"Number of descriptors based on twojmax : {nd}") + +# Run lammps with dbirjflag on +run_lammps(1) + +# Get global snap array +lmp_snap = lmp.numpy.extract_compute("snap",0, 2) + +# Extract dBj/dRi (includes dBi/dRi) +natoms = lmp.get_natoms() +fref1 = lmp_snap[0:natoms,-3:].flatten() +eref1 = lmp_snap[-6,0] +dbdr_length = np.shape(lmp_snap)[0]-(natoms)-6 # Length of neighborlist pruned dbdr array +dBdR = lmp_snap[natoms:(natoms+dbdr_length),:] +force_indices = lmp_snap[natoms:(natoms+dbdr_length),-3:].astype(np.int32) + +# Sum over neighbors j for each atom i, like dbirjflag=0 does. +array1 = np.zeros((3*natoms,nd)) +a = 0 +for k in range(0,nd): + for l in range(0,dbdr_length): + j = force_indices[l,0] + i = force_indices[l,1] + #array1[3*(i-1)+a,k] += dBdR[l,k] + array1[3*(i)+a,k] += dBdR[l,k] + a = a+1 + if (a>2): + a=0 + +# Run lammps with dbirjflag off +run_lammps(0) + +# Get global snap array +lmp_snap = lmp.numpy.extract_compute("snap",0, 2) +natoms = lmp.get_natoms() +fref2 = lmp_snap[natoms:(natoms+3*natoms),-1] +eref2 = lmp_snap[0,-1] +array2 = lmp_snap[natoms:natoms+(3*natoms), nd:-1] + +# Sum the arrays obtained from dbirjflag on and off. +summ = array1 + array2 +#np.savetxt("sum.dat", summ) + +print(f"Maximum difference in descriptor sums: {np.max(summ)}") +print(f"Maximum difference in reference forces: {np.max(fref1-fref2)}") +print(f"Difference in reference energy: {np.max(eref1-eref2)}") diff --git a/python/examples/in.lj b/python/examples/in.lj new file mode 100644 index 0000000000..3dc80bdfea --- /dev/null +++ b/python/examples/in.lj @@ -0,0 +1,25 @@ +# 3d Lennard-Jones melt + +units lj +atom_style atomic +atom_modify map array + +lattice fcc 0.8442 +region box block 0 4 0 4 0 4 +create_box 1 box +create_atoms 1 box +mass 1 1.0 + +velocity all create 1.44 87287 loop geom + +pair_style lj/cut 2.5 +pair_coeff 1 1 1.0 1.0 2.5 + +neighbor 0.3 bin +neigh_modify delay 0 every 20 check no + +fix 1 all nve + +variable fx atom fx + +run 10 diff --git a/python/examples/simple.py b/python/examples/simple.py index 8925ce48c0..2f9c191165 100755 --- a/python/examples/simple.py +++ b/python/examples/simple.py @@ -5,10 +5,10 @@ # Purpose: mimic operation of examples/COUPLE/simple/simple.cpp via Python # Serial syntax: simple.py in.lammps -# in.lammps = LAMMPS input script +# in.simple = LAMMPS input script -# Parallel syntax: mpirun -np 4 simple.py in.lammps -# in.lammps = LAMMPS input script +# Parallel syntax: mpirun -np 4 python simple.py in.simple +# in.simple = LAMMPS input script # also need to uncomment mpi4py sections below from __future__ import print_function @@ -27,9 +27,9 @@ infile = sys.argv[1] me = 0 # uncomment this if running in parallel via mpi4py -#from mpi4py import MPI -#me = MPI.COMM_WORLD.Get_rank() -#nprocs = MPI.COMM_WORLD.Get_size() +from mpi4py import MPI +me = MPI.COMM_WORLD.Get_rank() +nprocs = MPI.COMM_WORLD.Get_size() from lammps import lammps lmp = lammps() @@ -122,10 +122,10 @@ if me == 0: print("Gather post scatter subset:", boxlo,boxhi,xy,yz,xz,periodicity,box_change = lmp.extract_box() if me == 0: print("Box info",boxlo,boxhi,xy,yz,xz,periodicity,box_change) -lmp.reset_box([0,0,0],[10,10,8],0,0,0) +#lmp.reset_box([0,0,0],[10,10,8],0,0,0) -boxlo,boxhi,xy,yz,xz,periodicity,box_change = lmp.extract_box() -if me == 0: print("Box info",boxlo,boxhi,xy,yz,xz,periodicity,box_change) +#boxlo,boxhi,xy,yz,xz,periodicity,box_change = lmp.extract_box() +#if me == 0: print("Box info",boxlo,boxhi,xy,yz,xz,periodicity,box_change) # uncomment if running in parallel via mpi4py -#print("Proc %d out of %d procs has" % (me,nprocs), lmp) +print("Proc %d out of %d procs has" % (me,nprocs), lmp) diff --git a/src/ML-SNAP/compute_snap.cpp b/src/ML-SNAP/compute_snap.cpp index 3927703f01..d1b0980dfb 100644 --- a/src/ML-SNAP/compute_snap.cpp +++ b/src/ML-SNAP/compute_snap.cpp @@ -13,7 +13,6 @@ ------------------------------------------------------------------------- */ #include "compute_snap.h" - #include "sna.h" #include "atom.h" #include "update.h" @@ -25,6 +24,7 @@ #include "comm.h" #include "memory.h" #include "error.h" +#include "universe.h" // For MPI #include @@ -82,7 +82,6 @@ ComputeSnap::ComputeSnap(LAMMPS *lmp, int narg, char **arg) : memory->create(cutsq,ntypes+1,ntypes+1,"snap:cutsq"); for (int i = 1; i <= ntypes; i++) { cut = 2.0*radelem[i]*rcutfac; - //printf("cut: %f\n", cut); if (cut > cutmax) cutmax = cut; cutsq[i][i] = cut*cut; for (int j = i+1; j <= ntypes; j++) { @@ -201,10 +200,9 @@ ComputeSnap::ComputeSnap(LAMMPS *lmp, int narg, char **arg) : natoms = atom->natoms; bik_rows = 1; if (bikflag) bik_rows = natoms; - //size_array_rows = bik_rows+ndims_force*natoms+ndims_virial; dbirj_rows = ndims_force*natoms; size_array_rows = bik_rows+dbirj_rows+ndims_virial; - if (dbirjflag) size_array_cols = nperdim+3; // plus 3 for tag[i], tag[2], and cartesian index + if (dbirjflag) size_array_cols = nperdim+3; // plus 3 for tag[i], tag[j], and cartesian index else size_array_cols = nperdim*atom->ntypes+1; lastcol = size_array_cols-1; @@ -220,41 +218,25 @@ ComputeSnap::~ComputeSnap() { memory->destroy(snap); - //printf("---------------- 1\n"); memory->destroy(snapall); - //printf("---------------- 2\n"); memory->destroy(snap_peratom); - //printf("---------------- 3\n"); memory->destroy(radelem); - //printf("---------------- 4\n"); memory->destroy(wjelem); - //printf("---------------- 5\n"); memory->destroy(cutsq); - //printf("---------------- 6\n"); delete snaptr; - //printf("---------------- 7\n"); if (chemflag) memory->destroy(map); if (switchinnerflag) { memory->destroy(sinnerelem); memory->destroy(dinnerelem); } - //printf("---------------- 8\n"); if (dbirjflag){ - //printf("dbirj_rows: %d\n", dbirj_rows); - //printf("----- destroy dbirj\n"); memory->destroy(dbirj); - //printf("----- 1-1-1-1-1-1\n"); memory->destroy(nneighs); - //printf("----- 2-1-1-1-1-1\n"); memory->destroy(neighsum); - //printf("----- 3-1-1-1-1-1\n"); memory->destroy(icounter); - //printf("----- 4-1-1-1-1-1\n"); memory->destroy(dbiri); - //printf("----- 5-1-1-1-1-1\n"); } - //printf("---------------- 9\n"); } /* ---------------------------------------------------------------------- */ @@ -265,7 +247,6 @@ void ComputeSnap::init() error->all(FLERR,"Compute snap requires a pair style be defined"); if (cutmax > force->pair->cutforce){ - //printf("----- cutmax cutforce: %f %f\n", cutmax, force->pair->cutforce); error->all(FLERR,"Compute snap cutoff is longer than pairwise cutoff"); } @@ -279,7 +260,6 @@ void ComputeSnap::init() // allocate memory for global array - //printf("----- dbirjflag: %d\n", dbirjflag); memory->create(snap,size_array_rows,size_array_cols, "snap:snap"); memory->create(snapall,size_array_rows,size_array_cols, @@ -319,18 +299,10 @@ void ComputeSnap::init_list(int /*id*/, NeighList *ptr) void ComputeSnap::compute_array() { - //printf(" -----2 dbirjflag: %d\n", dbirjflag); if (dbirjflag){ - //printf("----- dbirjflag true.\n"); get_dbirj_length(); - //printf("----- got dbirj_length\n"); } - //else{ - // printf("----- dbirjflag false.\n"); - //} - //printf("----- cutmax cutforce: %f %f\n", cutmax, force->pair->cutforce); - //else{ int ntotal = atom->nlocal + atom->nghost; invoked_array = update->ntimestep; @@ -343,11 +315,10 @@ void ComputeSnap::compute_array() memory->create(snap_peratom,nmax,size_peratom, "snap:snap_peratom"); } + // clear global array - //printf("size_array_rows: %d\n", size_array_rows); for (int irow = 0; irow < size_array_rows; irow++){ for (int icoeff = 0; icoeff < size_array_cols; icoeff++){ - //printf("%d %d\n", irow, icoeff); snap[irow][icoeff] = 0.0; } } @@ -372,18 +343,13 @@ void ComputeSnap::compute_array() double** const x = atom->x; const int* const mask = atom->mask; - //printf("----- inum: %d\n", inum); - //printf("----- NEIGHMASK: %d\n", NEIGHMASK); int ninside; int numneigh_sum = 0; int dbirj_row_indx; for (int ii = 0; ii < inum; ii++) { int irow = 0; if (bikflag) irow = atom->tag[ilist[ii] & NEIGHMASK]-1; - //printf("----- i, itag: %d %d\n", ilist[ii] & NEIGHMASK, atom->tag[ilist[ii]]); const int i = ilist[ii]; - //printf("----- ii, i: %d %d\n", ii, i); - //printf("----- mask[i] groupbit: %d %d\n", mask[i], groupbit); if (mask[i] & groupbit) { const double xtmp = x[i][0]; @@ -408,12 +374,8 @@ void ComputeSnap::compute_array() // typej = types of neighbors of I within cutoff // note Rij sign convention => dU/dRij = dU/dRj = -dU/dRi - /* - This loop assigns quantities in snaptr. - snaptr is a SNA class instance, see sna.h + // assign quantities in snaptr - */ - //int ninside = 0; ninside=0; for (int jj = 0; jj < jnum; jj++) { int j = jlist[jj]; @@ -428,7 +390,6 @@ void ComputeSnap::compute_array() if (chemflag) jelem = map[jtype]; if (rsq < cutsq[itype][jtype]&&rsq>1e-20) { - //printf("cutsq: %f\n", cutsq[itype][jtype]); snaptr->rij[ninside][0] = delx; snaptr->rij[ninside][1] = dely; snaptr->rij[ninside][2] = delz; @@ -444,88 +405,36 @@ void ComputeSnap::compute_array() } } - /* - Now that we have assigned neighbor quantities with previous loop, we are ready to compute things. - Here we compute the wigner functions (U), Z is some other quantity, and bi is bispectrum. - */ + // compute bispectrum for atom i + snaptr->compute_ui(ninside, ielem); snaptr->compute_zi(); snaptr->compute_bi(ielem); - /* - Looks like this loop computes derivatives. - How does snaptr know what atom I we're dealing with? - I think it only needs neighbor info, and then it goes from there. - */ - //printf("----- Derivative loop - looping over neighbors j.\n"); - //printf("----- ninside: %d\n", ninside); // numneighs of I within cutoff + // loop over neighbors for descriptors derivatives + for (int jj = 0; jj < ninside; jj++) { - //printf("----- jj: %d\n", jj); const int j = snaptr->inside[jj]; - //printf("----- jj, j, jtag: %d %d %d\n", jj, j, atom->tag[j]); - //int dbirj_row_indx = 3*neighsum[i] + 3*jj ; // THIS IS WRONG, SEE NEXT LINE. - //int dbirj_row_indx = 3*neighsum[j] + 3*i_indx; // need to get i_indx. - // How to get i_indx? - /* - i_indx must start at zero and end at (nneighs[j]-1). - We can start a counter for each atom j. - Maybe this icounter can serve as an index for i as a neighbor of j. - icounter starts at zero and ends at (nneighs[j]-1). - */ - //icounter[atom->tag[j]-1] += 1; + if (dbirjflag){ - dbirj_row_indx = 3*neighsum[atom->tag[j]-1] + 3*icounter[atom->tag[j]-1] ; // THIS IS WRONG, SEE NEXT VAR. - //printf("jtag, icounter, dbirj_row_indx: %d, %d, %d %d %d\n", atom->tag[j], icounter[atom->tag[j]-1], dbirj_row_indx+0, dbirj_row_indx+1, dbirj_row_indx+2); + dbirj_row_indx = 3*neighsum[atom->tag[j]-1] + 3*icounter[atom->tag[j]-1] ; icounter[atom->tag[j]-1] += 1; } - //int dbirj_row_indx = 3*neighsum[atom->tag[j]-1] + 3*icounter[atom->tag[j]-1] ; // THIS IS WRONG, SEE NEXT VAR. - //printf("jtag, icounter, dbirj_row_indx: %d, %d, %d %d %d\n", atom->tag[j], icounter[atom->tag[j]-1], dbirj_row_indx+0, dbirj_row_indx+1, dbirj_row_indx+2); - //icounter[atom->tag[j]-1] += 1; - /* - j is an atom index starting from 0. - Use atom->tag[j] to get the atom in the box (index starts at 1). - Need to make sure that the order of these ij pairs is the same when multiplying by dE/dD later. - */ - //printf("----- jj, j, jtag: %d %d %d\n", jj, j, atom->tag[j]); + snaptr->compute_duidrj(jj); snaptr->compute_dbidrj(); // Accumulate dBi/dRi, -dBi/dRj - /* - snap_peratom[i] has type double * because each atom index has indices for descriptors. - */ double *snadi = snap_peratom[i]+typeoffset_local; double *snadj = snap_peratom[j]+typeoffset_local; - //printf("----- ncoeff: %d\n", ncoeff); - //printf("snadi: %f %f %f %f %f\n", snadi[0], snadi[1], snadi[2], snadi[3], snadi[4]); - //printf("----- typeoffset_local: %d\n", typeoffset_local); - //printf("snadi: "); - //for (int s=0; s<(ncoeff*3); s++){ - // printf("%f ", snadi[s]); - //} - /* - printf("snadj: "); - for (int s=0; s<(ncoeff*3); s++){ - printf("%f ", snadj[s]); - } - */ - //printf("\n"); - for (int icoeff = 0; icoeff < ncoeff; icoeff++) { - //printf("----- dblist[icoeff]: %f %f %f\n", snaptr->dblist[icoeff][0], snaptr->dblist[icoeff][1], snaptr->dblist[icoeff][2]); - /* - I think these are the descriptor derivatives. - Desriptor derivatives wrt atom i. - What exactly is being summed here? - This is a loop over descriptors or coeff k. - */ + for (int icoeff = 0; icoeff < ncoeff; icoeff++) { + snadi[icoeff] += snaptr->dblist[icoeff][0]; snadi[icoeff+yoffset] += snaptr->dblist[icoeff][1]; snadi[icoeff+zoffset] += snaptr->dblist[icoeff][2]; - /* - Descriptor derivatives wrt atom j - */ + snadj[icoeff] -= snaptr->dblist[icoeff][0]; snadj[icoeff+yoffset] -= snaptr->dblist[icoeff][1]; snadj[icoeff+zoffset] -= snaptr->dblist[icoeff][2]; @@ -546,11 +455,11 @@ void ComputeSnap::compute_array() dbirj[dbirj_row_indx+2][ncoeff+1] = atom->tag[j]-1; dbirj[dbirj_row_indx+2][ncoeff+2] = 2; } - // Accumulate dBi/dRi = sum (-dBi/dRj) for neighbors j of if i. + // Accumulate dBi/dRi = sum (-dBi/dRj) for neighbors j of if i dbiri[3*(atom->tag[i]-1)+0][icoeff] -= snaptr->dblist[icoeff][0]; dbiri[3*(atom->tag[i]-1)+1][icoeff] -= snaptr->dblist[icoeff][1]; dbiri[3*(atom->tag[i]-1)+2][icoeff] -= snaptr->dblist[icoeff][2]; - // Get last columns + // Get last columns which are i, j, and Cartesian index if (icoeff==(ncoeff-1)){ dbiri[3*(atom->tag[i]-1)+0][ncoeff] = atom->tag[i]-1; dbiri[3*(atom->tag[i]-1)+0][ncoeff+1] = atom->tag[i]-1; @@ -617,18 +526,13 @@ void ComputeSnap::compute_array() } } - } // for (int jj = 0; jj < ninside; jj++) - //printf("---- irow after jj loop: %d\n", irow); - - // Accumulate Bi - //printf("----- Accumulate Bi.\n"); + } // linear contributions int k; if (dbirjflag) k = 0; else k = typeoffset_global; for (int icoeff = 0; icoeff < ncoeff; icoeff++){ - //printf("----- %d %f\n", icoeff, snaptr->blist[icoeff]); snap[irow][k++] += snaptr->blist[icoeff]; } @@ -649,85 +553,25 @@ void ComputeSnap::compute_array() numneigh_sum += ninside; } // for (int ii = 0; ii < inum; ii++) - //printf("----- bik_rows: %d\n", bik_rows); - //printf("----- bikflag: %d\n", bikflag); - - // Check icounter. - /* - for (int ii = 0; ii < inum; ii++) { - const int i = ilist[ii]; - if (mask[i] & groupbit) { - printf("icounter[i]: %d\n", icounter[i]); - } - } - */ - - // Sum all the derivatives we calculated to check usual compute snap output. - /* - if (dbirjflag){ - fh_d = fopen("DEBUG", "w"); - int row_indx=0; - double sum; - for (int ii=0; iintypes); - //for (int itype = 0; itype < atom->ntypes; itype++) { int dbiri_indx; int irow; for (int itype=0; itype<1; itype++){ const int typeoffset_local = ndims_peratom*nperdim*itype; const int typeoffset_global = nperdim*itype; - //printf("----- nperdim: %d\n", nperdim); for (int icoeff = 0; icoeff < nperdim; icoeff++) { - //printf("----- icoeff: %d\n", icoeff); dbiri_indx=0; for (int i = 0; i < atom->nlocal; i++) { - //printf("i: %d\n", i); - //int dbiri_indx = 0; - //int irow; for (int jj=0; jjtag[i]-1] + 3*jj; int snap_row_indx = 3*neighsum[atom->tag[i]-1] + 3*(atom->tag[i]-1) + 3*jj; - //printf("snap_row_indx: %d\n", snap_row_indx); - //int irow = dbirj_row_indx+bik_rows; irow = snap_row_indx + bik_rows; - //printf(" row_indx, irow: %d %d\n", dbirj_row_indx, irow); + // x-coordinate snap[irow][icoeff+typeoffset_global] += dbirj[dbirj_row_indx+0][icoeff]; if (icoeff==(ncoeff-1)){ @@ -736,7 +580,7 @@ void ComputeSnap::compute_array() snap[irow][ncoeff+2] += dbirj[dbirj_row_indx+0][ncoeff+2]; } irow++; - //printf(" irow: %d\n", irow); + // y-coordinate snap[irow][icoeff+typeoffset_global] += dbirj[dbirj_row_indx+1][icoeff]; if (icoeff==(ncoeff-1)){ @@ -745,7 +589,7 @@ void ComputeSnap::compute_array() snap[irow][ncoeff+2] += dbirj[dbirj_row_indx+1][ncoeff+2]; } irow++; - //printf(" irow: %d\n", irow); + // z-coordinate snap[irow][icoeff+typeoffset_global] += dbirj[dbirj_row_indx+2][icoeff]; if (icoeff==(ncoeff-1)){ @@ -755,11 +599,11 @@ void ComputeSnap::compute_array() } dbiri_indx = dbiri_indx+3; } + // Put dBi/dRi at end of each dBj/dRi chunk. - //int dbiri_row_indx; + irow = dbiri_indx + bik_rows; - //printf("dbiri_indx: %d\n", dbiri_indx); - //printf("dbiri: %f %f %f\n", dbiri[3*i+0][icoeff], dbiri[3*i+1][icoeff], dbiri[3*i+2][icoeff]); + // x-coordinate snap[irow][icoeff+typeoffset_global] += dbiri[3*i+0][icoeff]; if (icoeff==(ncoeff-1)){ @@ -768,7 +612,7 @@ void ComputeSnap::compute_array() snap[irow][ncoeff+2] += dbiri[3*i+0][ncoeff+2]; } irow++; - //printf(" irow: %d\n", irow); + // y-coordinate snap[irow][icoeff+typeoffset_global] += dbiri[3*i+1][icoeff]; if (icoeff==(ncoeff-1)){ @@ -777,7 +621,8 @@ void ComputeSnap::compute_array() snap[irow][ncoeff+2] += dbiri[3*i+1][ncoeff+2]; } irow++; - //printf(" irow: %d\n", irow); + + // z-coordinate snap[irow][icoeff+typeoffset_global] += dbiri[3*i+2][icoeff]; if (icoeff==(ncoeff-1)){ snap[irow][ncoeff] += dbiri[3*i+2][ncoeff]; @@ -789,31 +634,21 @@ void ComputeSnap::compute_array() } } } - //printf(" Accumulated to global array.\n"); } else{ - //printf("----- Accumulate bispecturm force contributions to global array.\n"); + // accumulate bispectrum force contributions to global array - //printf("----- ntotal, nmax, natoms: %d %d %d\n", ntotal, nmax, atom->natoms); + for (int itype = 0; itype < atom->ntypes; itype++) { const int typeoffset_local = ndims_peratom*nperdim*itype; const int typeoffset_global = nperdim*itype; - //printf("----- nperdim: %d\n", nperdim); - /*nperdim = ncoeff set previsouly*/ for (int icoeff = 0; icoeff < nperdim; icoeff++) { - //printf("----- icoeff: %d\n", icoeff); for (int i = 0; i < ntotal; i++) { double *snadi = snap_peratom[i]+typeoffset_local; int iglobal = atom->tag[i]; - if (icoeff==4){ - if ( (snadi[icoeff] != 0.0) || (snadi[icoeff+yoffset] != 0.0) || (snadi[icoeff+zoffset] != 0.0) ){ - //printf("%d %d %f %f %f\n", i, iglobal, snadi[icoeff], snadi[icoeff+yoffset], snadi[icoeff+zoffset]); - } - } int irow = 3*(iglobal-1)+bik_rows; - //printf("----- snadi[icoeff]: %f\n", snadi[icoeff]); snap[irow++][icoeff+typeoffset_global] += snadi[icoeff]; snap[irow++][icoeff+typeoffset_global] += snadi[icoeff+yoffset]; snap[irow][icoeff+typeoffset_global] += snadi[icoeff+zoffset]; @@ -822,15 +657,11 @@ void ComputeSnap::compute_array() } } - //printf("----- Accumulate forces to global array.\n"); - /* - These are the last columns. - */ // accumulate forces to global array + if (dbirjflag){ + // for dbirjflag=1, put forces at last 3 columns of bik rows for (int i=0; inlocal; i++){ - - int iglobal = atom->tag[i]; snap[iglobal-1][ncoeff+0] = atom->f[i][0]; snap[iglobal-1][ncoeff+1] = atom->f[i][1]; @@ -842,11 +673,8 @@ void ComputeSnap::compute_array() for (int i = 0; i < atom->nlocal; i++) { int iglobal = atom->tag[i]; int irow = 3*(iglobal-1)+bik_rows; - //printf("---- irow: %d\n", irow); snap[irow++][lastcol] = atom->f[i][0]; - //printf("---- irow: %d\n", irow); snap[irow++][lastcol] = atom->f[i][1]; - //printf("---- irow: %d\n", irow); snap[irow][lastcol] = atom->f[i][2]; } } @@ -854,7 +682,7 @@ void ComputeSnap::compute_array() // accumulate bispectrum virial contributions to global array if (dbirjflag){ - + // no virial terms for dbirj yet } else{ dbdotr_compute(); @@ -865,8 +693,8 @@ void ComputeSnap::compute_array() // assign energy to last column if (dbirjflag){ // Assign reference energy right after the dbirj rows, first column. - int irow = bik_rows + dbirj_rows + 3*natoms; // add 3N for the dBi/dRi rows - //printf("irow bik_rows dbirj_rows: %d %d %d\n", irow, bik_rows, dbirj_rows); + // Add 3N for the dBi/dRi rows. + int irow = bik_rows + dbirj_rows + 3*natoms; double reference_energy = c_pe->compute_scalar(); snapall[irow][0] = reference_energy; } @@ -882,7 +710,7 @@ void ComputeSnap::compute_array() c_virial->compute_vector(); if (dbirjflag){ - + // no virial terms for dbirj yet } else{ int irow = 3*natoms+bik_rows; @@ -894,7 +722,6 @@ void ComputeSnap::compute_array() snapall[irow][lastcol] = c_virial->vector[3]; } - //}// else } /* ---------------------------------------------------------------------- @@ -906,14 +733,7 @@ void ComputeSnap::dbdotr_compute() { double **x = atom->x; - int irow0; - if (dbirjflag){ - irow0 = bik_rows+dbirj_rows+(3*natoms); - } - else{ - irow0 = bik_rows+ndims_force*natoms; - } - //int irow0 = bik_rows+ndims_force*natoms; + int irow0 = bik_rows+ndims_force*natoms; // sum over bispectrum contributions to forces // on all particles including ghosts @@ -946,9 +766,11 @@ void ComputeSnap::dbdotr_compute() void ComputeSnap::get_dbirj_length() { + int rank = universe->me; // for MPI debugging + memory->destroy(snap); memory->destroy(snapall); - // invoke full neighbor list (will copy or build if necessary) + // invoke full neighbor list neighbor->build_one(list); dbirj_rows = 0; const int inum = list->inum; @@ -958,12 +780,20 @@ void ComputeSnap::get_dbirj_length() int * const type = atom->type; const int* const mask = atom->mask; double** const x = atom->x; - //printf("----- inum: %d\n", inum); + /* memory->create(neighsum, inum, "snap:neighsum"); memory->create(nneighs, inum, "snap:nneighs"); memory->create(icounter, inum, "snap:icounter"); memory->create(dbiri, 3*atom->nlocal,ncoeff+3, "snap:dbiri"); - for (int ii=0; ii<3*atom->nlocal; ii++){ + */ + memory->create(neighsum, natoms, "snap:neighsum"); + memory->create(nneighs, natoms, "snap:nneighs"); + memory->create(icounter, natoms, "snap:icounter"); + memory->create(dbiri, 3*natoms,ncoeff+3, "snap:dbiri"); + if (atom->nlocal != natoms){ + error->all(FLERR,"Compute snap dbirjflag=1 does not support parallelism."); + } + for (int ii=0; ii<3*natoms; ii++){ for (int icoeff=0; icoeffcreate(dbirj, dbirj_rows, ncoeff+3, "snap:dbirj"); for (int i=0; inlocal; // Add 3*N for dBi/dRi - //printf("----- dbirj_rows: %d\n", dbirj_rows); - //printf("----- end of dbirj length.\n"); memory->create(snap,size_array_rows,size_array_cols, "snap:snap"); memory->create(snapall,size_array_rows,size_array_cols, "snap:snapall"); From 06ffed196560ede27b9a730dac29a82b04d93d2f Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Fri, 17 Jun 2022 12:11:13 -0600 Subject: [PATCH 394/585] update doc pages --- doc/src/Howto_mdi.rst | 45 ++++++++++++++++++---------- doc/src/fix_mdi_qm.rst | 23 +++++++++++--- doc/src/mdi.rst | 68 +++++++++++++++++++++++++++++++----------- 3 files changed, 99 insertions(+), 37 deletions(-) diff --git a/doc/src/Howto_mdi.rst b/doc/src/Howto_mdi.rst index f9147f44d9..578f98e61e 100644 --- a/doc/src/Howto_mdi.rst +++ b/doc/src/Howto_mdi.rst @@ -5,9 +5,9 @@ Client/server coupling of two (or more) codes is where one code is the "client" and sends request messages (data) to one (or more) "server" code(s). A server responds to each request with a reply message (data). This enables two (or more) codes to work in tandem to perform -a simulation. LAMMPS can act as either a client or server code; it -does this by using the `MolSSI Driver Interface (MDI) library -`_, +a simulation. In this context, LAMMPS can act as either a client or +server code. It does this by using the `MolSSI Driver Interface (MDI) +library `_, developed by the `Molecular Sciences Software Institute (MolSSI) `_, which is supported by the :ref:`MDI ` package. @@ -80,11 +80,22 @@ scripts for all of these use cases. The examples/mdi directory contains Python scripts and LAMMPS input script which use LAMMPS as either an MDI driver or engine or both. -Three example use cases are provided: +Currently, 5 example use cases are provided: -* Run ab initio MD (AIMD) using 2 instances of LAMMPS, one as driver - and one as an engine. As an engine, LAMMPS is a surrogate for a - quantum code. +* Run ab initio MD (AIMD) using 2 instances of LAMMPS. As a driver + LAMMPS performs the timestepping in either NVE or NPT mode. As an + engine, LAMMPS computes forces and is a surrogate for a quantum + code. + +* As a driver, LAMMPS runs an MD simulation. Every N steps it passes + the current snapshot to an MDI engine to evaluate the energy, + virial, and peratom forces. As the engine LAMMPS is a surrogate for + a quantum code. + +* As a driver, LAMMPS loops over a series of data files and passes the + configuration to an MDI engine to evaluate the energy, virial, and + peratom forces. As the engine LAMMPS is a surrogate for a quantum + code. * A Python script driver invokes a sequence of unrelated LAMMPS calculations. Calculations can be single-point energy/force @@ -97,20 +108,22 @@ Three example use cases are provided: Note that in any of these example where LAMMPS is used as an engine, an actual QM code (which supports MDI) could be used in its place, -without modifying other code or scripts, except to specify the name of -the QM code. +without modifying the input scripts or launch commands, except to +specify the name of the QM code. -The examples/mdi/README file explains how to launch both driver and +The examples/mdi/Run.sh file illustrates how to launch both driver and engine codes so that they communicate using the MDI library via either -MPI or sockets. +MPI or sockets. Or using the engine as a stand-alone code or plugin +library. ------------- -Currently there are two quantum DFT codes which have direct MDI -support, `Quantum ESPRESSO (QE) `_ -and `INQ `_. There are also -several QM codes which have indirect support through QCEngine or i-PI. -The former means they require a wrapper program (QCEngine) with MDI +Currently there are at least two quantum DFT codes which have direct +MDI support, `Quantum ESPRESSO (QE) +`_ and `INQ +`_. There are also several QM +codes which have indirect support through QCEngine or i-PI. The +former means they require a wrapper program (QCEngine) with MDI support which writes/read files to pass data to the quantum code itself. The list of QCEngine-supported and i-PI-supported quantum codes is on the `MDI webpage diff --git a/doc/src/fix_mdi_qm.rst b/doc/src/fix_mdi_qm.rst index 5c66ac2639..8ecb6ed488 100644 --- a/doc/src/fix_mdi_qm.rst +++ b/doc/src/fix_mdi_qm.rst @@ -13,7 +13,7 @@ Syntax * ID, group-ID are documented in :doc:`fix ` command * mdi/qm = style name of this fix command * zero or more keyword/value pairs may be appended -* keyword = *virial* or *add* or *every* +* keyword = *virial* or *add* or *every* or *connect* .. parsed-literal:: @@ -25,6 +25,9 @@ Syntax no = do not add returned values to LAMMPS quantities *every* args = Nevery Nevery = request values from server code once every Nevery steps + *connect* args = *yes* or *no* + yes = perform a one-time connection to the MDI engine code + no = do not perform the connection operation Examples """""""" @@ -66,7 +69,7 @@ information about how LAMMPS can operate as either an MDI driver or engine. The examples/mdi directory contains input scripts using this fix in -the various use cases listed above. In each case, two instances of +the various use cases dicussed below. In each case, two instances of LAMMPS are used, once as an MDI driver, once as an MDI engine (surrogate for a QM code). The examples/mdi/README file explains how to launch two codes so that they communicate via the MDI library using @@ -104,9 +107,21 @@ during a dynamics run with the current LAMMPS simulation box and configuration of atoms. The QM code will be called once every *Nevery* timesteps. +The *connect* keyword determines whether this fix performs a one-time +connection to the QM code. The default is *yes*. The only time a +*no* is needed is if this command is used multiple times in an input +script. E.g. if it used inside a loop which also uses the :doc:`clear +` command to destroy the system (including any defined fixes). +See the examples/mdi/in.series.driver script as an example of this, +where LAMMPS is using the QM code to compute energy and forces for a +series of system configurations. In this use case *connect no* +is used along with the :doc:`mdi connect and exit ` command +to one-time initiate/terminate the connection outside the loop. + ---------- -3 example use cases: +The following 3 example use cases are illustrated in the examples/mdi +directory. See its README file for more details. (1) To run an ab initio MD (AIMD) dynamics simulation, or an energy minimization with QM forces, or a multi-replica NEB calculation, use @@ -243,4 +258,4 @@ Default """"""" The default for the optional keywords are virial = no, add = yes, -every = 1. +every = 1, connect = yes. diff --git a/doc/src/mdi.rst b/doc/src/mdi.rst index 73e245697e..0d647bbd4e 100644 --- a/doc/src/mdi.rst +++ b/doc/src/mdi.rst @@ -8,9 +8,9 @@ Syntax .. parsed-literal:: - mdi mode args + mdi option args -* mode = *engine* or *plugin* +* option = *engine* or *plugin* or *connect* or *exit* .. parsed-literal:: @@ -22,7 +22,8 @@ Syntax *infile* value = filename the engine will read at start-up *extra* value = aditional command-line args to pass to engine library when loaded *command* value = a LAMMPS input script command to execute - + *connect* args = none + *exit* args = none Examples """""""" @@ -33,23 +34,15 @@ Examples mdi plugin lammps mdi "-role ENGINE -name lammps -method LINK" & infile in.aimd.engine extra "-log log.aimd.engine.plugin" & command "run 5" + mdi connect + mdi exit Description """"""""""" -This command implements two high-level operations within LAMMPS to use -the `MDI Library -` for -coupling to other codes in a client/server protocol. - -The *engine* mode enables LAMMPS to act as an MDI engine (server), -responding to requests from an MDI driver (client) code. - -The *plugin* mode enables LAMMPS to act as an MDI driver (client), and -load the MDI engine (server) code as a library plugin. In this case -the MDI engine is a library plugin. It can also be a stand-alone -code, launched separately from LAMMPS, in which case the mdi plugin -command is not used. +This command implements operations within LAMMPS to use the `MDI +Library ` +for coupling to other codes in a client/server protocol. See the Howto MDI doc page for a discussion of all the different ways 2 or more codes can interact via MDI. @@ -61,6 +54,22 @@ stand-alone code or as a plugin. The README file in that directory shows how to launch and couple codes for all the 4 usage modes, and so they communicate via the MDI library using either MPI or sockets. +The scripts in that directory illustrate the use of all the options +for this command. + +The *engine* option enables LAMMPS to act as an MDI engine (server), +responding to requests from an MDI driver (client) code. + +The *plugin* option enables LAMMPS to act as an MDI driver (client), +and load the MDI engine (server) code as a library plugin. In this +case the MDI engine is a library plugin. An MDI engine can also be a +stand-alone code, launched separately from LAMMPS, in which case the +mdi plugin command is not used. + +The *connect* and *exit* options are only used when LAMMPS is acting +as an MDI driver. As explained below, these options are normally not +needed, except for a specific kind of use case. + ---------- The *mdi engine* command is used to make LAMMPS operate as an MDI @@ -121,7 +130,7 @@ commands, which are described further below. * - TOLERANCE - Send 4 tolerance parameters for next MD minimization via OPTG command * - >TYPES or ` command. If it is only used once in an input script +then it can initiate and terminate the connection. But if it is being +issuedd multiple times, e.g. in a loop that issues a :doc:`clear +` command, then it cannot initiate/terminate the connection +multiple times. Instead, the *mdi connect* and *mdi exit* commands +should be used outside the loop to intiate/terminate the connection. + +See the examples/mdi/in.series.driver script for an example of how +this is done. The LOOP in that script is reading a series of data +file configurations and passing them to an MDI engine (e.g. quantum +code) for enery and force evaluation. A *clear* command inside the +loop wipes out the current system so a new one can be defined. This +operation also destroys all fixes. So the :doc:`fix mdi/qm +` command is issued once per loop iteration. Note that it +includes a "connect no" option which disables the initiate/terminate +logic within that fix. + Restrictions """""""""""" From b46773e39869e0cc73fc91fdd776a76f401e4b69 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 17 Jun 2022 15:53:04 -0400 Subject: [PATCH 395/585] add support for writing a dump file footer --- src/EXTRA-DUMP/dump_yaml.cpp | 6 ++++++ src/EXTRA-DUMP/dump_yaml.h | 1 + src/dump.cpp | 2 ++ src/dump.h | 2 ++ 4 files changed, 11 insertions(+) diff --git a/src/EXTRA-DUMP/dump_yaml.cpp b/src/EXTRA-DUMP/dump_yaml.cpp index d4f3208ffb..be1c9768bf 100644 --- a/src/EXTRA-DUMP/dump_yaml.cpp +++ b/src/EXTRA-DUMP/dump_yaml.cpp @@ -124,6 +124,12 @@ void DumpYAML::write_data(int n, double *mybuf) } fputs("]\n", fp); } +} + +/* ---------------------------------------------------------------------- */ + +void DumpYAML::write_footer() +{ fputs("...\n", fp); } diff --git a/src/EXTRA-DUMP/dump_yaml.h b/src/EXTRA-DUMP/dump_yaml.h index bf621dcb51..60ab894de4 100644 --- a/src/EXTRA-DUMP/dump_yaml.h +++ b/src/EXTRA-DUMP/dump_yaml.h @@ -35,6 +35,7 @@ class DumpYAML : public DumpCustom { void write() override; void write_header(bigint) override; void write_data(int, double *) override; + void write_footer() override; int modify_param(int, char **) override; }; diff --git a/src/dump.cpp b/src/dump.cpp index 3569d32165..a354be4f04 100644 --- a/src/dump.cpp +++ b/src/dump.cpp @@ -517,6 +517,8 @@ void Dump::write() if (refreshflag) modify->compute[irefresh]->refresh(); + if (filewriter && fp != nullptr) write_footer(); + // if file per timestep, close file if I am filewriter if (multifile) { diff --git a/src/dump.h b/src/dump.h index a95029ada8..90866a3567 100644 --- a/src/dump.h +++ b/src/dump.h @@ -153,6 +153,8 @@ class Dump : protected Pointers { virtual void pack(tagint *) = 0; virtual int convert_string(int, double *) { return 0; } virtual void write_data(int, double *) = 0; + virtual void write_footer() {} + void pbc_allocate(); double compute_time(); From 0e6bbf8dffed7483bca320d66cc0347070dc0c48 Mon Sep 17 00:00:00 2001 From: rohskopf Date: Fri, 17 Jun 2022 14:16:03 -0600 Subject: [PATCH 396/585] Remove files from other branch. --- src/fix_move.cpp | 247 ++--------------------------------------------- src/fix_move.h | 55 ----------- 2 files changed, 8 insertions(+), 294 deletions(-) diff --git a/src/fix_move.cpp b/src/fix_move.cpp index 7cf5567028..37e8647671 100644 --- a/src/fix_move.cpp +++ b/src/fix_move.cpp @@ -35,16 +35,11 @@ #include #include -#include -#include -#include -#include - using namespace LAMMPS_NS; using namespace FixConst; using namespace MathConst; -enum { LINEAR, WIGGLE, ROTATE, VARIABLE, TRANSROT, WIGGLE_EIGEN }; +enum { LINEAR, WIGGLE, ROTATE, VARIABLE, TRANSROT }; enum { EQUAL, ATOM }; #define INERTIA 0.2 // moment of inertia prefactor for ellipsoid @@ -192,80 +187,7 @@ FixMove::FixMove(LAMMPS *lmp, int narg, char **arg) : } else error->all(FLERR, "Illegal fix move command"); - } - // Fix move wiggle_eigen - else if (strcmp(arg[3], "wiggle_eigen") == 0) { - int natoms = atom->natoms; - int nlocal = atom->nlocal; - printf("----- fix move wiggle_eigen initialize -----\n"); - printf("natoms: %d\n", natoms); - memory->create(emat,natoms*3,natoms*3,"move:emat"); - memory->create(freq,natoms*3,"move:freq"); - - // Read EMAT - std::ifstream readfile2; - for (int i = 0; i < natoms*3; i++) { - for (int j = 0; j < natoms*3; j++) { - emat[i][j] = 0.0; - } - } - readfile2.open("../EMAT"); - //readfile2.open("ev_real.txt"); - if (!readfile2.is_open()) { - //printf("ASDFASDF"); - printf("Unable to open ../EMAT\n"); - exit(1); - } - //printf("natoms: %d\n", natoms); - for (int i=0;i<3*natoms;i++){ - for (int j=0;j<3*natoms;j++){ - readfile2>>emat[i][j]; - } - } - - // Read FREQUENCIES - std::ifstream readfile3; - for (int i = 0; i < natoms*3; i++) { - freq[i]=0.0; - } - readfile3.open("FREQUENCIES"); - //readfile2.open("ev_real.txt"); - - if (!readfile3.is_open()) { - printf("Unable to open FREQUENCIES.\n"); - exit(1); - } - //printf("natoms: %d\n", natoms); - for (int i=0;i<3*natoms;i++){ - readfile3>>freq[i]; - } - - - if (narg < 8) error->all(FLERR, "Illegal fix move command"); - iarg = 8; - mstyle = WIGGLE_EIGEN; - if (strcmp(arg[4], "NULL") == 0) - axflag = 0; - else { - axflag = 1; - ax = utils::numeric(FLERR, arg[4], false, lmp); - } - if (strcmp(arg[5], "NULL") == 0) - ayflag = 0; - else { - ayflag = 1; - ay = utils::numeric(FLERR, arg[5], false, lmp); - } - if (strcmp(arg[6], "NULL") == 0) - azflag = 0; - else { - azflag = 1; - az = utils::numeric(FLERR, arg[6], false, lmp); - } - period = utils::numeric(FLERR, arg[7], false, lmp); - if (period <= 0.0) error->all(FLERR, "Illegal fix move command"); - } - else + } else error->all(FLERR, "Illegal fix move command"); // optional args @@ -314,10 +236,6 @@ FixMove::FixMove(LAMMPS *lmp, int narg, char **arg) : if (axflag) ax *= xscale; if (ayflag) ay *= yscale; if (azflag) az *= zscale; - } else if (mstyle == WIGGLE_EIGEN) { - if (axflag) ax *= xscale; - if (ayflag) ay *= yscale; - if (azflag) az *= zscale; } else if (mstyle == ROTATE) { point[0] *= xscale; point[1] *= yscale; @@ -334,7 +252,7 @@ FixMove::FixMove(LAMMPS *lmp, int narg, char **arg) : // set omega_rotate from period - if ((mstyle == WIGGLE) || (mstyle == ROTATE) || (mstyle == TRANSROT) || (mstyle == WIGGLE_EIGEN)) + if ((mstyle == WIGGLE) || (mstyle == ROTATE) || (mstyle == TRANSROT)) omega_rotate = MY_2PI / period; // runit = unit vector along rotation axis @@ -377,10 +295,10 @@ FixMove::FixMove(LAMMPS *lmp, int narg, char **arg) : // AtomVec pointers to retrieve per-atom storage of extra quantities - avec_ellipsoid = dynamic_cast( atom->style_match("ellipsoid")); - avec_line = dynamic_cast( atom->style_match("line")); - avec_tri = dynamic_cast( atom->style_match("tri")); - avec_body = dynamic_cast( atom->style_match("body")); + avec_ellipsoid = dynamic_cast(atom->style_match("ellipsoid")); + avec_line = dynamic_cast(atom->style_match("line")); + avec_tri = dynamic_cast(atom->style_match("tri")); + avec_body = dynamic_cast(atom->style_match("body")); // xoriginal = initial unwrapped positions of atoms // toriginal = initial theta of lines @@ -462,11 +380,6 @@ FixMove::~FixMove() memory->destroy(displace); memory->destroy(velocity); - if (mstyle==WIGGLE_EIGEN){ - memory->destroy(emat); - memory->destroy(freq); - } - delete[] xvarstr; delete[] yvarstr; delete[] zvarstr; @@ -582,7 +495,7 @@ void FixMove::init() velocity = nullptr; if (utils::strmatch(update->integrate_style, "^respa")) - nlevels_respa = (dynamic_cast( update->integrate))->nlevels; + nlevels_respa = (dynamic_cast(update->integrate))->nlevels; } /* ---------------------------------------------------------------------- @@ -614,7 +527,6 @@ void FixMove::initial_integrate(int /*vflag*/) int *tri = atom->tri; int *body = atom->body; int *mask = atom->mask; - int *tag = atom->tag; int nlocal = atom->nlocal; @@ -740,142 +652,6 @@ void FixMove::initial_integrate(int /*vflag*/) // X = P + C + A cos(w*dt) + B sin(w*dt) // V = w R0 cross (A cos(w*dt) + B sin(w*dt)) -} else if (mstyle == WIGGLE_EIGEN) { - //printf("----- Wiggling!-----\n"); - int modeindx = 10; - //printf("%f %f\n", omega_rotate, MY_2PI*freq[modeindx]); - omega_rotate = MY_2PI*freq[modeindx]; - double arg = omega_rotate * delta; - double sine = sin(arg); - double cosine = cos(arg); - - //printf("arg: %f\n", arg); - for (int alpha=0; alpha<3; alpha++){ - for (int i=0; iremap_near(x[i], xold); - } - - } - - - } - - /* - for (int i=0; iremap_near(x[i], xold); - } - - } - */ - - /* - for (int i = 0; i < nlocal; i++) { - if (mask[i] & groupbit) { - xold[0] = x[i][0]; - xold[1] = x[i][1]; - xold[2] = x[i][2]; - - if (axflag) { - v[i][0] = ax * omega_rotate * cosine; - x[i][0] = xoriginal[i][0] + ax * sine; - } else if (rmass) { - dtfm = dtf / rmass[i]; - v[i][0] += dtfm * f[i][0]; - x[i][0] += dtv * v[i][0]; - } else { - dtfm = dtf / mass[type[i]]; - v[i][0] += dtfm * f[i][0]; - x[i][0] += dtv * v[i][0]; - } - - if (ayflag) { - v[i][1] = ay * omega_rotate * cosine; - x[i][1] = xoriginal[i][1] + ay * sine; - } else if (rmass) { - dtfm = dtf / rmass[i]; - v[i][1] += dtfm * f[i][1]; - x[i][1] += dtv * v[i][1]; - } else { - dtfm = dtf / mass[type[i]]; - v[i][1] += dtfm * f[i][1]; - x[i][1] += dtv * v[i][1]; - } - - if (azflag) { - v[i][2] = az * omega_rotate * cosine; - x[i][2] = xoriginal[i][2] + az * sine; - } else if (rmass) { - dtfm = dtf / rmass[i]; - v[i][2] += dtfm * f[i][2]; - x[i][2] += dtv * v[i][2]; - } else { - dtfm = dtf / mass[type[i]]; - v[i][2] += dtfm * f[i][2]; - x[i][2] += dtv * v[i][2]; - } - - domain->remap_near(x[i], xold); - } - } - */ - // for rotate by right-hand rule around omega: - // P = point = vector = point of rotation - // R = vector = axis of rotation - // w = omega of rotation (from period) - // X0 = xoriginal = initial coord of atom - // R0 = runit = unit vector for R - // D = X0 - P = vector from P to X0 - // C = (D dot R0) R0 = projection of atom coord onto R line - // A = D - C = vector from R line to X0 - // B = R0 cross A = vector perp to A in plane of rotation - // A,B define plane of circular rotation around R line - // X = P + C + A cos(w*dt) + B sin(w*dt) - // V = w R0 cross (A cos(w*dt) + B sin(w*dt)) - } else if (mstyle == ROTATE) { double arg = omega_rotate * delta; double cosine = cos(arg); @@ -1527,13 +1303,6 @@ void FixMove::set_arrays(int i) if (ayflag) xoriginal[i][1] -= ay * sine; if (azflag) xoriginal[i][2] -= az * sine; -} else if (mstyle == WIGGLE_EIGEN) { - double arg = omega_rotate * delta; - double sine = sin(arg); - if (axflag) xoriginal[i][0] -= ax * sine; - if (ayflag) xoriginal[i][1] -= ay * sine; - if (azflag) xoriginal[i][2] -= az * sine; - } else if (mstyle == ROTATE) { double a[3], b[3], c[3], d[3], disp[3], ddotr; double arg = -omega_rotate * delta; diff --git a/src/fix_move.h b/src/fix_move.h index 8023a66c1b..e6b253a2a2 100644 --- a/src/fix_move.h +++ b/src/fix_move.h @@ -73,11 +73,6 @@ class FixMove : public Fix { int maxatom; double **displace, **velocity; - // fix move wiggle_eigen variables - - double **emat; - double *freq; - class AtomVecEllipsoid *avec_ellipsoid; class AtomVecLine *avec_line; class AtomVecTri *avec_tri; @@ -88,53 +83,3 @@ class FixMove : public Fix { #endif #endif - -/* ERROR/WARNING messages: - -E: Illegal ... command - -Self-explanatory. Check the input script syntax and compare to the -documentation for the command. You can use -echo screen as a -command-line option when running LAMMPS to see the offending line. - -E: Fix move cannot set linear z motion for 2d problem - -Self-explanatory. - -E: Fix move cannot set wiggle z motion for 2d problem - -Self-explanatory. - -E: Fix move cannot rotate around non z-axis for 2d problem - -UNDOCUMENTED - -E: Fix move cannot define z or vz variable for 2d problem - -Self-explanatory. - -E: Zero length rotation vector with fix move - -Self-explanatory. - -E: Variable name for fix move does not exist - -Self-explanatory. - -E: Variable for fix move is invalid style - -Only equal-style variables can be used. - -E: Cannot add atoms to fix move variable - -Atoms can not be added afterwards to this fix option. - -E: Resetting timestep size is not allowed with fix move - -This is because fix move is moving atoms based on elapsed time. - -U: Fix move cannot rotate aroung non z-axis for 2d problem - -Self-explanatory. - -*/ From 86f0a62ee0454694f8fe8ed9cc2e68ce27138327 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Fri, 17 Jun 2022 17:16:02 -0600 Subject: [PATCH 397/585] Cleaned up programming style --- doc/src/compute_sna_atom.rst | 46 ++++++++++++++++++++---------------- src/compute_grid.cpp | 5 ---- src/compute_grid.h | 1 - src/compute_grid_local.cpp | 4 ---- src/compute_grid_local.h | 1 - 5 files changed, 26 insertions(+), 31 deletions(-) diff --git a/doc/src/compute_sna_atom.rst b/doc/src/compute_sna_atom.rst index 5f777685fd..242defe614 100644 --- a/doc/src/compute_sna_atom.rst +++ b/doc/src/compute_sna_atom.rst @@ -15,6 +15,12 @@ compute snav/atom command compute snap command ==================== +compute sna/grid command +======================== + +compute sna/grid/local command +============================== + Syntax """""" @@ -222,13 +228,13 @@ bispectrum components for a regular grid of points. These are calculated from the local density of nearby atoms *i'* around each grid point, as if there was a central atom *i* at the grid point. This is useful for characterizing fine-scale -structure in a configuration of atoms, and it has been used -to build a machine-learning surrogate for finite-temperature Kohn-Sham -density functional theory (:ref:`Ellis et al. `). +structure in a configuration of atoms, and it is used +in the `MALA package `_ +to build machine-learning surrogates for finite-temperature Kohn-Sham +density functional theory (:ref:`Ellis et al. `) Neighbor atoms not in the group do not contribute to the bispectrum components of the grid points. The distance cutoff :math:`R_{ii'}` -and other parameters are defined as for a central atom with the same type as the -neighbor atoms *i'*. +assumes that *i* has the same type as the neighbor atom *i'*. Compute *sna/grid* calculates a global array containing bispectrum components for a regular grid of points. @@ -688,6 +694,21 @@ number of columns in the global array generated by *snap* are 31, and 931, respectively, while the number of rows is 1+3\*\ *N*\ +6, where *N* is the total number of atoms. +Compute *sna/grid* evaluates a global array. +The array contains one row for each of the +:math:`nx \times ny \times nz` grid points, looping over the index for *ix* fastest, +then *iy*, and *iz* slowest. Each row of the array contains the *x*, *y*, +and *z* coordinates of the grid point, followed by the bispectrum +components. + +Compute *sna/grid/local* evaluates a local array. +The array contains one row for each of the +local grid points, looping over the global index *ix* fastest, +then *iy*, and *iz* slowest. Each row of the array contains +the global indexes *ix*, *iy*, and *iz* first, followed by the *x*, *y*, +and *z* coordinates of the grid point, followed by the bispectrum +components. + If the *quadratic* keyword value is set to 1, then additional columns are generated, corresponding to the products of all distinct pairs of bispectrum components. If the number of bispectrum components is *K*, @@ -715,21 +736,6 @@ page for an overview of LAMMPS output options. To see how this command can be used within a Python workflow to train SNAP potentials, see the examples in `FitSNAP `_. -Compute *sna/grid* evaluates a global array. -The array contains one row for each of the -:math:`nx \times ny \times nz` grid points, looping over the index for *ix* fastest, -then *iy*, and *iz* slowest. Each row of the array contains the *x*, *y*, -and *z* coordinates of the grid point, followed by the bispectrum -components. - -Compute *sna/grid/local* evaluates a local array. -The array contains one row for each of the -local grid points, looping over the global index *ix* fastest, -then *iy*, and *iz* slowest. Each row of the array contains -the global indexes *ix*, *iy*, and *iz* first, followed by the *x*, *y*, -and *z* coordinates of the grid point, followed by the bispectrum -components. - Restrictions """""""""""" diff --git a/src/compute_grid.cpp b/src/compute_grid.cpp index 0a8ba5a697..7a5ffe1e24 100644 --- a/src/compute_grid.cpp +++ b/src/compute_grid.cpp @@ -66,10 +66,6 @@ ComputeGrid::~ComputeGrid() /* ---------------------------------------------------------------------- */ -void ComputeGrid::init() {} - -/* ---------------------------------------------------------------------- */ - void ComputeGrid::setup() { deallocate(); @@ -120,7 +116,6 @@ void ComputeGrid::allocate() { // allocate arrays - printf("In allocate() %d %d \n", size_array_rows, size_array_cols); memory->create(grid, size_array_rows, size_array_cols, "grid:grid"); memory->create(gridall, size_array_rows, size_array_cols, "grid:gridall"); if (nxlo <= nxhi && nylo <= nyhi && nzlo <= nzhi) { diff --git a/src/compute_grid.h b/src/compute_grid.h index 96338a035d..84b3bc4e98 100644 --- a/src/compute_grid.h +++ b/src/compute_grid.h @@ -22,7 +22,6 @@ class ComputeGrid : public Compute { public: ComputeGrid(class LAMMPS *, int, char **); ~ComputeGrid() override; - void init() override; void setup() override; void compute_array() override = 0; diff --git a/src/compute_grid_local.cpp b/src/compute_grid_local.cpp index 5f341680bd..48714962ac 100644 --- a/src/compute_grid_local.cpp +++ b/src/compute_grid_local.cpp @@ -70,10 +70,6 @@ ComputeGridLocal::~ComputeGridLocal() /* ---------------------------------------------------------------------- */ -void ComputeGridLocal::init() {} - -/* ---------------------------------------------------------------------- */ - void ComputeGridLocal::setup() { deallocate(); diff --git a/src/compute_grid_local.h b/src/compute_grid_local.h index b34dd2d096..5bc6f2082a 100644 --- a/src/compute_grid_local.h +++ b/src/compute_grid_local.h @@ -22,7 +22,6 @@ class ComputeGridLocal : public Compute { public: ComputeGridLocal(class LAMMPS *, int, char **); ~ComputeGridLocal() override; - void init() override; void setup() override; void compute_local() override = 0; From 44436c0eb662fb4e396c8496354bbe59b04e3f31 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Fri, 17 Jun 2022 17:24:34 -0600 Subject: [PATCH 398/585] Cleaned up programming style --- src/ML-SNAP/compute_sna_atom.cpp | 151 ++++++++--------- src/ML-SNAP/compute_sna_atom.h | 1 + src/ML-SNAP/compute_sna_grid.cpp | 92 +++++----- src/ML-SNAP/compute_sna_grid.h | 2 - src/ML-SNAP/compute_sna_grid_local.cpp | 114 ++++++------- src/ML-SNAP/compute_sna_grid_local.h | 2 - src/ML-SNAP/compute_snad_atom.cpp | 157 ++++++++--------- src/ML-SNAP/compute_snad_atom.h | 2 +- src/ML-SNAP/compute_snap.cpp | 177 ++++++++++--------- src/ML-SNAP/compute_snap.h | 2 +- src/ML-SNAP/compute_snav_atom.cpp | 224 +++++++++++++------------ src/ML-SNAP/compute_snav_atom.h | 3 +- 12 files changed, 460 insertions(+), 467 deletions(-) diff --git a/src/ML-SNAP/compute_sna_atom.cpp b/src/ML-SNAP/compute_sna_atom.cpp index 5f24ebeaa6..69f233b1c3 100644 --- a/src/ML-SNAP/compute_sna_atom.cpp +++ b/src/ML-SNAP/compute_sna_atom.cpp @@ -30,25 +30,28 @@ using namespace LAMMPS_NS; +#define SNAPCOMPUTENAME "sna/atom" + ComputeSNAAtom::ComputeSNAAtom(LAMMPS *lmp, int narg, char **arg) : Compute(lmp, narg, arg), cutsq(nullptr), list(nullptr), sna(nullptr), radelem(nullptr), wjelem(nullptr), sinnerelem(nullptr), dinnerelem(nullptr) { - double rmin0, rfac0; + // code common to all SNAP computes + + double rfac0, rmin0; int twojmax, switchflag, bzeroflag, bnormflag, wselfallflag; int ntypes = atom->ntypes; - int nargmin = 6+2*ntypes; + int nargmin = 6 + 2 * ntypes; - if (narg < nargmin) error->all(FLERR,"Illegal compute sna/atom command"); + if (narg < nargmin) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); // default values rmin0 = 0.0; switchflag = 1; bzeroflag = 1; - bnormflag = 0; quadraticflag = 0; chemflag = 0; bnormflag = 0; @@ -56,32 +59,34 @@ ComputeSNAAtom::ComputeSNAAtom(LAMMPS *lmp, int narg, char **arg) : switchinnerflag = 0; nelements = 1; - // offset by 1 to match up with types + // process required arguments - memory->create(radelem,ntypes+1,"sna/atom:radelem"); - memory->create(wjelem,ntypes+1,"sna/atom:wjelem"); + memory->create(radelem, ntypes + 1, "sna/atom:radelem"); // offset by 1 to match up with types + memory->create(wjelem, ntypes + 1, "sna/atom:wjelem"); - rcutfac = atof(arg[3]); - rfac0 = atof(arg[4]); - twojmax = atoi(arg[5]); + rcutfac = utils::numeric(FLERR, arg[3], false, lmp); + rfac0 = utils::numeric(FLERR, arg[4], false, lmp); + twojmax = utils::inumeric(FLERR, arg[5], false, lmp); for (int i = 0; i < ntypes; i++) - radelem[i+1] = atof(arg[6+i]); + radelem[i + 1] = + utils::numeric(FLERR, arg[6 + i], false, lmp); for (int i = 0; i < ntypes; i++) - wjelem[i+1] = atof(arg[6+ntypes+i]); + wjelem[i + 1] = + utils::numeric(FLERR, arg[6 + ntypes + i], false, lmp); // construct cutsq double cut; cutmax = 0.0; - memory->create(cutsq,ntypes+1,ntypes+1,"sna/atom:cutsq"); + memory->create(cutsq, ntypes + 1, ntypes + 1, "sna/atom:cutsq"); for (int i = 1; i <= ntypes; i++) { - cut = 2.0*radelem[i]*rcutfac; + cut = 2.0 * radelem[i] * rcutfac; if (cut > cutmax) cutmax = cut; - cutsq[i][i] = cut*cut; - for (int j = i+1; j <= ntypes; j++) { - cut = (radelem[i]+radelem[j])*rcutfac; - cutsq[i][j] = cutsq[j][i] = cut*cut; + cutsq[i][i] = cut * cut; + for (int j = i + 1; j <= ntypes; j++) { + cut = (radelem[i] + radelem[j]) * rcutfac; + cutsq[i][j] = cutsq[j][i] = cut * cut; } } @@ -95,89 +100,85 @@ ComputeSNAAtom::ComputeSNAAtom(LAMMPS *lmp, int narg, char **arg) : int iarg = nargmin; while (iarg < narg) { - if (strcmp(arg[iarg],"rmin0") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute sna/atom command"); - rmin0 = atof(arg[iarg+1]); + if (strcmp(arg[iarg], "rmin0") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + rmin0 = utils::numeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; - } else if (strcmp(arg[iarg],"switchflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute sna/atom command"); - switchflag = atoi(arg[iarg+1]); + } else if (strcmp(arg[iarg], "switchflag") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + switchflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; - } else if (strcmp(arg[iarg],"bzeroflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute sna/atom command"); - bzeroflag = atoi(arg[iarg+1]); + } else if (strcmp(arg[iarg], "bzeroflag") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + bzeroflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; - } else if (strcmp(arg[iarg],"quadraticflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute sna/atom command"); - quadraticflag = atoi(arg[iarg+1]); + } else if (strcmp(arg[iarg], "quadraticflag") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + quadraticflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; - } else if (strcmp(arg[iarg],"chem") == 0) { - if (iarg+2+ntypes > narg) - error->all(FLERR,"Illegal compute sna/atom command"); + } else if (strcmp(arg[iarg], "chem") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); chemflag = 1; - memory->create(map,ntypes+1,"compute_sna_atom:map"); - nelements = utils::inumeric(FLERR,arg[iarg+1],false,lmp); + memory->create(map, ntypes + 1, "compute_sna_grid:map"); + nelements = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); for (int i = 0; i < ntypes; i++) { - int jelem = utils::inumeric(FLERR,arg[iarg+2+i],false,lmp); - if (jelem < 0 || jelem >= nelements) - error->all(FLERR,"Illegal compute sna/atom command"); - map[i+1] = jelem; + int jelem = utils::inumeric(FLERR, arg[iarg + 2 + i], false, lmp); + if (jelem < 0 || jelem >= nelements) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + map[i + 1] = jelem; } - iarg += 2+ntypes; - } else if (strcmp(arg[iarg],"bnormflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute sna/atom command"); - bnormflag = atoi(arg[iarg+1]); + iarg += 2 + ntypes; + } else if (strcmp(arg[iarg], "bnormflag") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + bnormflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; - } else if (strcmp(arg[iarg],"wselfallflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute sna/atom command"); - wselfallflag = atoi(arg[iarg+1]); + } else if (strcmp(arg[iarg], "wselfallflag") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + wselfallflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; - } else if (strcmp(arg[iarg],"switchinnerflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute sna/atom command"); - switchinnerflag = atoi(arg[iarg+1]); + } else if (strcmp(arg[iarg], "switchinnerflag") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + switchinnerflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; - } else if (strcmp(arg[iarg],"sinner") == 0) { + } else if (strcmp(arg[iarg], "sinner") == 0) { iarg++; - if (iarg+ntypes > narg) - error->all(FLERR,"Illegal compute sna/atom command"); - memory->create(sinnerelem,ntypes+1,"sna/atom:sinnerelem"); + if (iarg + ntypes > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + memory->create(sinnerelem, ntypes + 1, "snap:sinnerelem"); for (int i = 0; i < ntypes; i++) - sinnerelem[i+1] = utils::numeric(FLERR,arg[iarg+i],false,lmp); + sinnerelem[i + 1] = utils::numeric(FLERR, arg[iarg + i], false, lmp); sinnerflag = 1; iarg += ntypes; - } else if (strcmp(arg[iarg],"dinner") == 0) { + } else if (strcmp(arg[iarg], "dinner") == 0) { iarg++; - if (iarg+ntypes > narg) - error->all(FLERR,"Illegal compute sna/atom command"); - memory->create(dinnerelem,ntypes+1,"sna/atom:dinnerelem"); + if (iarg + ntypes > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + memory->create(dinnerelem, ntypes + 1, "snap:dinnerelem"); for (int i = 0; i < ntypes; i++) - dinnerelem[i+1] = utils::numeric(FLERR,arg[iarg+i],false,lmp); + dinnerelem[i + 1] = utils::numeric(FLERR, arg[iarg + i], false, lmp); dinnerflag = 1; iarg += ntypes; - } else error->all(FLERR,"Illegal compute sna/atom command"); + } else + error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); } if (switchinnerflag && !(sinnerflag && dinnerflag)) - error->all(FLERR,"Illegal compute sna/atom command: switchinnerflag = 1, missing sinner/dinner keyword"); + error->all( + FLERR, + "Illegal compute ", SNAPCOMPUTENAME, " command: switchinnerflag = 1, missing sinner/dinner keyword"); if (!switchinnerflag && (sinnerflag || dinnerflag)) - error->all(FLERR,"Illegal compute sna/atom command: switchinnerflag = 0, unexpected sinner/dinner keyword"); + error->all( + FLERR, + "Illegal compute ", SNAPCOMPUTENAME, " command: switchinnerflag = 0, unexpected sinner/dinner keyword"); - snaptr = new SNA(lmp, rfac0, twojmax, - rmin0, switchflag, bzeroflag, - chemflag, bnormflag, wselfallflag, - nelements, switchinnerflag); + snaptr = new SNA(lmp, rfac0, twojmax, rmin0, switchflag, bzeroflag, chemflag, bnormflag, + wselfallflag, nelements, switchinnerflag); ncoeff = snaptr->ncoeff; - size_peratom_cols = ncoeff; - if (quadraticflag) size_peratom_cols += (ncoeff*(ncoeff+1))/2; + nvalues = ncoeff; + if (quadraticflag) nvalues += (ncoeff * (ncoeff + 1)) / 2; + + // end code common to all SNAP computes + + size_peratom_cols = nvalues; peratom_flag = 1; nmax = 0; diff --git a/src/ML-SNAP/compute_sna_atom.h b/src/ML-SNAP/compute_sna_atom.h index 7d1ebfa2f8..059062670f 100644 --- a/src/ML-SNAP/compute_sna_atom.h +++ b/src/ML-SNAP/compute_sna_atom.h @@ -50,6 +50,7 @@ class ComputeSNAAtom : public Compute { class SNA *snaptr; double cutmax; int quadraticflag; + int nvalues; }; } // namespace LAMMPS_NS diff --git a/src/ML-SNAP/compute_sna_grid.cpp b/src/ML-SNAP/compute_sna_grid.cpp index e182b16d64..4c8e4f82ef 100644 --- a/src/ML-SNAP/compute_sna_grid.cpp +++ b/src/ML-SNAP/compute_sna_grid.cpp @@ -15,17 +15,11 @@ #include "atom.h" #include "comm.h" -#include "domain.h" #include "error.h" #include "force.h" #include "memory.h" #include "modify.h" -#include "neigh_list.h" -#include "neigh_request.h" -#include "neighbor.h" -#include "pair.h" #include "sna.h" -#include "tokenizer.h" #include "update.h" #include @@ -33,12 +27,11 @@ using namespace LAMMPS_NS; +#define SNAPCOMPUTENAME "sna/grid" + ComputeSNAGrid::ComputeSNAGrid(LAMMPS *lmp, int narg, char **arg) : ComputeGrid(lmp, narg, arg), cutsq(nullptr), radelem(nullptr), wjelem(nullptr) { - double rfac0, rmin0; - int twojmax, switchflag, bzeroflag, bnormflag, wselfallflag; - // skip over arguments used by base class // so that argument positions are identical to // regular per-atom compute @@ -46,10 +39,15 @@ ComputeSNAGrid::ComputeSNAGrid(LAMMPS *lmp, int narg, char **arg) : arg += nargbase; narg -= nargbase; + // code common to all SNAP computes + + double rfac0, rmin0; + int twojmax, switchflag, bzeroflag, bnormflag, wselfallflag; + int ntypes = atom->ntypes; int nargmin = 6 + 2 * ntypes; - if (narg < nargmin) error->all(FLERR, "Illegal compute sna/grid command"); + if (narg < nargmin) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); // default values @@ -65,15 +63,19 @@ ComputeSNAGrid::ComputeSNAGrid(LAMMPS *lmp, int narg, char **arg) : // process required arguments - memory->create(radelem, ntypes + 1, "sna/grid:radelem"); // offset by 1 to match up with types + memory->create(radelem, ntypes + 1, "sna/grid:radelem"); // offset by 1 to match up with types memory->create(wjelem, ntypes + 1, "sna/grid:wjelem"); - rcutfac = atof(arg[3]); - rfac0 = atof(arg[4]); - twojmax = atoi(arg[5]); + rcutfac = utils::numeric(FLERR, arg[3], false, lmp); + rfac0 = utils::numeric(FLERR, arg[4], false, lmp); + twojmax = utils::inumeric(FLERR, arg[5], false, lmp); - for (int i = 0; i < ntypes; i++) radelem[i + 1] = atof(arg[6 + i]); - for (int i = 0; i < ntypes; i++) wjelem[i + 1] = atof(arg[6 + ntypes + i]); + for (int i = 0; i < ntypes; i++) + radelem[i + 1] = + utils::numeric(FLERR, arg[6 + i], false, lmp); + for (int i = 0; i < ntypes; i++) + wjelem[i + 1] = + utils::numeric(FLERR, arg[6 + ntypes + i], false, lmp); // construct cutsq @@ -101,47 +103,47 @@ ComputeSNAGrid::ComputeSNAGrid(LAMMPS *lmp, int narg, char **arg) : while (iarg < narg) { if (strcmp(arg[iarg], "rmin0") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute sna/grid command"); - rmin0 = atof(arg[iarg + 1]); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + rmin0 = utils::numeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "switchflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute sna/grid command"); - switchflag = atoi(arg[iarg + 1]); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + switchflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "bzeroflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute sna/grid command"); - bzeroflag = atoi(arg[iarg + 1]); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + bzeroflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "quadraticflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute sna/grid command"); - quadraticflag = atoi(arg[iarg + 1]); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + quadraticflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "chem") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute sna/grid command"); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); chemflag = 1; memory->create(map, ntypes + 1, "compute_sna_grid:map"); nelements = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); for (int i = 0; i < ntypes; i++) { int jelem = utils::inumeric(FLERR, arg[iarg + 2 + i], false, lmp); - if (jelem < 0 || jelem >= nelements) error->all(FLERR, "Illegal compute sna/grid command"); + if (jelem < 0 || jelem >= nelements) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); map[i + 1] = jelem; } iarg += 2 + ntypes; } else if (strcmp(arg[iarg], "bnormflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute sna/grid command"); - bnormflag = atoi(arg[iarg + 1]); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + bnormflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "wselfallflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute sna/grid command"); - wselfallflag = atoi(arg[iarg + 1]); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + wselfallflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "switchinnerflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute sna/grid command"); - switchinnerflag = atoi(arg[iarg + 1]); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + switchinnerflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "sinner") == 0) { iarg++; - if (iarg + ntypes > narg) error->all(FLERR, "Illegal compute sna/grid command"); + if (iarg + ntypes > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); memory->create(sinnerelem, ntypes + 1, "snap:sinnerelem"); for (int i = 0; i < ntypes; i++) sinnerelem[i + 1] = utils::numeric(FLERR, arg[iarg + i], false, lmp); @@ -149,25 +151,25 @@ ComputeSNAGrid::ComputeSNAGrid(LAMMPS *lmp, int narg, char **arg) : iarg += ntypes; } else if (strcmp(arg[iarg], "dinner") == 0) { iarg++; - if (iarg + ntypes > narg) error->all(FLERR, "Illegal compute sna/grid command"); + if (iarg + ntypes > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); memory->create(dinnerelem, ntypes + 1, "snap:dinnerelem"); for (int i = 0; i < ntypes; i++) dinnerelem[i + 1] = utils::numeric(FLERR, arg[iarg + i], false, lmp); dinnerflag = 1; iarg += ntypes; } else - error->all(FLERR, "Illegal compute sna/grid command"); + error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); } if (switchinnerflag && !(sinnerflag && dinnerflag)) error->all( FLERR, - "Illegal compute sna/grid command: switchinnerflag = 1, missing sinner/dinner keyword"); + "Illegal compute ", SNAPCOMPUTENAME, " command: switchinnerflag = 1, missing sinner/dinner keyword"); if (!switchinnerflag && (sinnerflag || dinnerflag)) error->all( FLERR, - "Illegal compute sna/grid command: switchinnerflag = 0, unexpected sinner/dinner keyword"); + "Illegal compute ", SNAPCOMPUTENAME, " command: switchinnerflag = 0, unexpected sinner/dinner keyword"); snaptr = new SNA(lmp, rfac0, twojmax, rmin0, switchflag, bzeroflag, chemflag, bnormflag, wselfallflag, nelements, switchinnerflag); @@ -175,6 +177,9 @@ ComputeSNAGrid::ComputeSNAGrid(LAMMPS *lmp, int narg, char **arg) : ncoeff = snaptr->ncoeff; nvalues = ncoeff; if (quadraticflag) nvalues += (ncoeff * (ncoeff + 1)) / 2; + + // end code common to all SNAP computes + size_array_cols = size_array_cols_base + nvalues; array_flag = 1; } @@ -195,22 +200,13 @@ ComputeSNAGrid::~ComputeSNAGrid() void ComputeSNAGrid::init() { - int count = 0; - for (int i = 0; i < modify->ncompute; i++) - if (strcmp(modify->compute[i]->style, "sna/grid") == 0) count++; - if (count > 1 && comm->me == 0) error->warning(FLERR, "More than one compute sna/grid"); + if ((modify->get_compute_by_style("sna/grid").size() > 1) && (comm->me == 0)) + error->warning(FLERR, "More than one instance of compute sna/grid"); snaptr->init(); } /* ---------------------------------------------------------------------- */ -void ComputeSNAGrid::init_list(int /*id*/, NeighList *ptr) -{ - list = ptr; -} - -/* ---------------------------------------------------------------------- */ - void ComputeSNAGrid::compute_array() { invoked_array = update->ntimestep; diff --git a/src/ML-SNAP/compute_sna_grid.h b/src/ML-SNAP/compute_sna_grid.h index 7eef027ef7..839003dc2e 100644 --- a/src/ML-SNAP/compute_sna_grid.h +++ b/src/ML-SNAP/compute_sna_grid.h @@ -29,14 +29,12 @@ class ComputeSNAGrid : public ComputeGrid { ComputeSNAGrid(class LAMMPS *, int, char **); ~ComputeSNAGrid() override; void init() override; - void init_list(int, class NeighList *) override; void compute_array() override; double memory_usage() override; private: int ncoeff; double **cutsq; - class NeighList *list; double rcutfac; double *radelem; double *wjelem; diff --git a/src/ML-SNAP/compute_sna_grid_local.cpp b/src/ML-SNAP/compute_sna_grid_local.cpp index 7359acacbf..d9d66787f4 100644 --- a/src/ML-SNAP/compute_sna_grid_local.cpp +++ b/src/ML-SNAP/compute_sna_grid_local.cpp @@ -15,17 +15,11 @@ #include "atom.h" #include "comm.h" -#include "domain.h" #include "error.h" #include "force.h" #include "memory.h" #include "modify.h" -#include "neigh_list.h" -#include "neigh_request.h" -#include "neighbor.h" -#include "pair.h" #include "sna.h" -#include "tokenizer.h" #include "update.h" #include @@ -33,12 +27,11 @@ using namespace LAMMPS_NS; +#define SNAPCOMPUTENAME "sna/grid/local" + ComputeSNAGridLocal::ComputeSNAGridLocal(LAMMPS *lmp, int narg, char **arg) : ComputeGridLocal(lmp, narg, arg), cutsq(nullptr), radelem(nullptr), wjelem(nullptr) { - double rfac0, rmin0; - int twojmax, switchflag, bzeroflag, bnormflag, wselfallflag; - // skip over arguments used by base class // so that argument positions are identical to // regular per-atom compute @@ -46,10 +39,15 @@ ComputeSNAGridLocal::ComputeSNAGridLocal(LAMMPS *lmp, int narg, char **arg) : arg += nargbase; narg -= nargbase; + // code common to all SNAP computes + + double rfac0, rmin0; + int twojmax, switchflag, bzeroflag, bnormflag, wselfallflag; + int ntypes = atom->ntypes; int nargmin = 6 + 2 * ntypes; - if (narg < nargmin) error->all(FLERR, "Illegal compute sna/grid/local command"); + if (narg < nargmin) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); // default values @@ -63,23 +61,21 @@ ComputeSNAGridLocal::ComputeSNAGridLocal(LAMMPS *lmp, int narg, char **arg) : switchinnerflag = 0; nelements = 1; - // set local input checks - - int sinnerflag = 0; - int dinnerflag = 0; - // process required arguments - memory->create(radelem, ntypes + 1, - "sna/grid/local:radelem"); // offset by 1 to match up with types + memory->create(radelem, ntypes + 1, "sna/grid/local:radelem"); // offset by 1 to match up with types memory->create(wjelem, ntypes + 1, "sna/grid/local:wjelem"); - rcutfac = atof(arg[3]); - rfac0 = atof(arg[4]); - twojmax = atoi(arg[5]); + rcutfac = utils::numeric(FLERR, arg[3], false, lmp); + rfac0 = utils::numeric(FLERR, arg[4], false, lmp); + twojmax = utils::inumeric(FLERR, arg[5], false, lmp); - for (int i = 0; i < ntypes; i++) radelem[i + 1] = atof(arg[6 + i]); - for (int i = 0; i < ntypes; i++) wjelem[i + 1] = atof(arg[6 + ntypes + i]); + for (int i = 0; i < ntypes; i++) + radelem[i + 1] = + utils::numeric(FLERR, arg[6 + i], false, lmp); + for (int i = 0; i < ntypes; i++) + wjelem[i + 1] = + utils::numeric(FLERR, arg[6 + ntypes + i], false, lmp); // construct cutsq @@ -96,54 +92,58 @@ ComputeSNAGridLocal::ComputeSNAGridLocal(LAMMPS *lmp, int narg, char **arg) : } } + // set local input checks + + int sinnerflag = 0; + int dinnerflag = 0; + // process optional args int iarg = nargmin; while (iarg < narg) { if (strcmp(arg[iarg], "rmin0") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute sna/grid/local command"); - rmin0 = atof(arg[iarg + 1]); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + rmin0 = utils::numeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "switchflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute sna/grid/local command"); - switchflag = atoi(arg[iarg + 1]); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + switchflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "bzeroflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute sna/grid/local command"); - bzeroflag = atoi(arg[iarg + 1]); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + bzeroflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "quadraticflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute sna/grid/local command"); - quadraticflag = atoi(arg[iarg + 1]); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + quadraticflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "chem") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute sna/grid/local command"); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); chemflag = 1; - memory->create(map, ntypes + 1, "compute_sna_grid_local:map"); + memory->create(map, ntypes + 1, "compute_sna_grid:map"); nelements = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); for (int i = 0; i < ntypes; i++) { int jelem = utils::inumeric(FLERR, arg[iarg + 2 + i], false, lmp); - if (jelem < 0 || jelem >= nelements) - error->all(FLERR, "Illegal compute sna/grid/local command"); + if (jelem < 0 || jelem >= nelements) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); map[i + 1] = jelem; } iarg += 2 + ntypes; } else if (strcmp(arg[iarg], "bnormflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute sna/grid/local command"); - bnormflag = atoi(arg[iarg + 1]); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + bnormflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "wselfallflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute sna/grid/local command"); - wselfallflag = atoi(arg[iarg + 1]); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + wselfallflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "switchinnerflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute sna/grid/local command"); - switchinnerflag = atoi(arg[iarg + 1]); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + switchinnerflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "sinner") == 0) { iarg++; - if (iarg + ntypes > narg) error->all(FLERR, "Illegal compute sna/grid/local command"); + if (iarg + ntypes > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); memory->create(sinnerelem, ntypes + 1, "snap:sinnerelem"); for (int i = 0; i < ntypes; i++) sinnerelem[i + 1] = utils::numeric(FLERR, arg[iarg + i], false, lmp); @@ -151,25 +151,25 @@ ComputeSNAGridLocal::ComputeSNAGridLocal(LAMMPS *lmp, int narg, char **arg) : iarg += ntypes; } else if (strcmp(arg[iarg], "dinner") == 0) { iarg++; - if (iarg + ntypes > narg) error->all(FLERR, "Illegal compute sna/grid/local command"); + if (iarg + ntypes > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); memory->create(dinnerelem, ntypes + 1, "snap:dinnerelem"); for (int i = 0; i < ntypes; i++) dinnerelem[i + 1] = utils::numeric(FLERR, arg[iarg + i], false, lmp); dinnerflag = 1; iarg += ntypes; } else - error->all(FLERR, "Illegal compute sna/grid/local command"); + error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); } if (switchinnerflag && !(sinnerflag && dinnerflag)) - error->all(FLERR, - "Illegal compute sna/grid/local command: switchinnerflag = 1, missing sinner/dinner " - "keyword"); + error->all( + FLERR, + "Illegal compute ", SNAPCOMPUTENAME, " command: switchinnerflag = 1, missing sinner/dinner keyword"); if (!switchinnerflag && (sinnerflag || dinnerflag)) - error->all(FLERR, - "Illegal compute sna/grid/local command: switchinnerflag = 0, unexpected " - "sinner/dinner keyword"); + error->all( + FLERR, + "Illegal compute ", SNAPCOMPUTENAME, " command: switchinnerflag = 0, unexpected sinner/dinner keyword"); snaptr = new SNA(lmp, rfac0, twojmax, rmin0, switchflag, bzeroflag, chemflag, bnormflag, wselfallflag, nelements, switchinnerflag); @@ -177,6 +177,9 @@ ComputeSNAGridLocal::ComputeSNAGridLocal(LAMMPS *lmp, int narg, char **arg) : ncoeff = snaptr->ncoeff; nvalues = ncoeff; if (quadraticflag) nvalues += (ncoeff * (ncoeff + 1)) / 2; + + // end code common to all SNAP computes + size_local_cols = size_local_cols_base + nvalues; } @@ -196,22 +199,13 @@ ComputeSNAGridLocal::~ComputeSNAGridLocal() void ComputeSNAGridLocal::init() { - int count = 0; - for (int i = 0; i < modify->ncompute; i++) - if (strcmp(modify->compute[i]->style, "sna/grid/local") == 0) count++; - if (count > 1 && comm->me == 0) error->warning(FLERR, "More than one compute sna/grid/local"); + if ((modify->get_compute_by_style("sna/grid/local").size() > 1) && (comm->me == 0)) + error->warning(FLERR, "More than one instance of compute sna/grid/local"); snaptr->init(); } /* ---------------------------------------------------------------------- */ -void ComputeSNAGridLocal::init_list(int /*id*/, NeighList *ptr) -{ - list = ptr; -} - -/* ---------------------------------------------------------------------- */ - void ComputeSNAGridLocal::compute_local() { invoked_array = update->ntimestep; diff --git a/src/ML-SNAP/compute_sna_grid_local.h b/src/ML-SNAP/compute_sna_grid_local.h index 760d0de8cc..60f93b92b0 100644 --- a/src/ML-SNAP/compute_sna_grid_local.h +++ b/src/ML-SNAP/compute_sna_grid_local.h @@ -29,14 +29,12 @@ class ComputeSNAGridLocal : public ComputeGridLocal { ComputeSNAGridLocal(class LAMMPS *, int, char **); ~ComputeSNAGridLocal() override; void init() override; - void init_list(int, class NeighList *) override; void compute_local() override; double memory_usage() override; private: int ncoeff; double **cutsq; - class NeighList *list; double rcutfac; double *radelem; double *wjelem; diff --git a/src/ML-SNAP/compute_snad_atom.cpp b/src/ML-SNAP/compute_snad_atom.cpp index 838d8a85c9..c9a88da535 100644 --- a/src/ML-SNAP/compute_snad_atom.cpp +++ b/src/ML-SNAP/compute_snad_atom.cpp @@ -30,24 +30,27 @@ using namespace LAMMPS_NS; +#define SNAPCOMPUTENAME "snad/atom" + ComputeSNADAtom::ComputeSNADAtom(LAMMPS *lmp, int narg, char **arg) : Compute(lmp, narg, arg), cutsq(nullptr), list(nullptr), snad(nullptr), radelem(nullptr), wjelem(nullptr), sinnerelem(nullptr), dinnerelem(nullptr) { + // code common to all SNAP computes + double rfac0, rmin0; int twojmax, switchflag, bzeroflag, bnormflag, wselfallflag; int ntypes = atom->ntypes; - int nargmin = 6+2*ntypes; + int nargmin = 6 + 2 * ntypes; - if (narg < nargmin) error->all(FLERR,"Illegal compute snad/atom command"); + if (narg < nargmin) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); // default values rmin0 = 0.0; switchflag = 1; bzeroflag = 1; - bnormflag = 0; quadraticflag = 0; chemflag = 0; bnormflag = 0; @@ -57,28 +60,32 @@ ComputeSNADAtom::ComputeSNADAtom(LAMMPS *lmp, int narg, char **arg) : // process required arguments - memory->create(radelem,ntypes+1,"snad/atom:radelem"); // offset by 1 to match up with types - memory->create(wjelem,ntypes+1,"snad/atom:wjelem"); - rcutfac = atof(arg[3]); - rfac0 = atof(arg[4]); - twojmax = atoi(arg[5]); + memory->create(radelem, ntypes + 1, "snad/atom:radelem"); // offset by 1 to match up with types + memory->create(wjelem, ntypes + 1, "snad/atom:wjelem"); + + rcutfac = utils::numeric(FLERR, arg[3], false, lmp); + rfac0 = utils::numeric(FLERR, arg[4], false, lmp); + twojmax = utils::inumeric(FLERR, arg[5], false, lmp); + for (int i = 0; i < ntypes; i++) - radelem[i+1] = atof(arg[6+i]); + radelem[i + 1] = + utils::numeric(FLERR, arg[6 + i], false, lmp); for (int i = 0; i < ntypes; i++) - wjelem[i+1] = atof(arg[6+ntypes+i]); + wjelem[i + 1] = + utils::numeric(FLERR, arg[6 + ntypes + i], false, lmp); // construct cutsq double cut; cutmax = 0.0; - memory->create(cutsq,ntypes+1,ntypes+1,"snad/atom:cutsq"); + memory->create(cutsq, ntypes + 1, ntypes + 1, "snad/atom:cutsq"); for (int i = 1; i <= ntypes; i++) { - cut = 2.0*radelem[i]*rcutfac; + cut = 2.0 * radelem[i] * rcutfac; if (cut > cutmax) cutmax = cut; - cutsq[i][i] = cut*cut; - for (int j = i+1; j <= ntypes; j++) { - cut = (radelem[i]+radelem[j])*rcutfac; - cutsq[i][j] = cutsq[j][i] = cut*cut; + cutsq[i][i] = cut * cut; + for (int j = i + 1; j <= ntypes; j++) { + cut = (radelem[i] + radelem[j]) * rcutfac; + cutsq[i][j] = cutsq[j][i] = cut * cut; } } @@ -92,93 +99,87 @@ ComputeSNADAtom::ComputeSNADAtom(LAMMPS *lmp, int narg, char **arg) : int iarg = nargmin; while (iarg < narg) { - if (strcmp(arg[iarg],"rmin0") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute snad/atom command"); - rmin0 = atof(arg[iarg+1]); + if (strcmp(arg[iarg], "rmin0") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + rmin0 = utils::numeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; - } else if (strcmp(arg[iarg],"bzeroflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute snad/atom command"); - bzeroflag = atoi(arg[iarg+1]); + } else if (strcmp(arg[iarg], "switchflag") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + switchflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; - } else if (strcmp(arg[iarg],"switchflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute snad/atom command"); - switchflag = atoi(arg[iarg+1]); + } else if (strcmp(arg[iarg], "bzeroflag") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + bzeroflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; - } else if (strcmp(arg[iarg],"quadraticflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute snad/atom command"); - quadraticflag = atoi(arg[iarg+1]); + } else if (strcmp(arg[iarg], "quadraticflag") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + quadraticflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; - } else if (strcmp(arg[iarg],"chem") == 0) { - if (iarg+2+ntypes > narg) - error->all(FLERR,"Illegal compute snad/atom command"); + } else if (strcmp(arg[iarg], "chem") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); chemflag = 1; - memory->create(map,ntypes+1,"compute_snad_atom:map"); - nelements = utils::inumeric(FLERR,arg[iarg+1],false,lmp); + memory->create(map, ntypes + 1, "compute_sna_grid:map"); + nelements = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); for (int i = 0; i < ntypes; i++) { - int jelem = utils::inumeric(FLERR,arg[iarg+2+i],false,lmp); - if (jelem < 0 || jelem >= nelements) - error->all(FLERR,"Illegal compute snad/atom command"); - map[i+1] = jelem; + int jelem = utils::inumeric(FLERR, arg[iarg + 2 + i], false, lmp); + if (jelem < 0 || jelem >= nelements) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + map[i + 1] = jelem; } - iarg += 2+ntypes; - } else if (strcmp(arg[iarg],"bnormflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute snad/atom command"); - bnormflag = atoi(arg[iarg+1]); + iarg += 2 + ntypes; + } else if (strcmp(arg[iarg], "bnormflag") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + bnormflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; - } else if (strcmp(arg[iarg],"wselfallflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute snad/atom command"); - wselfallflag = atoi(arg[iarg+1]); + } else if (strcmp(arg[iarg], "wselfallflag") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + wselfallflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; - } else if (strcmp(arg[iarg],"switchinnerflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute snad/atom command"); - switchinnerflag = atoi(arg[iarg+1]); + } else if (strcmp(arg[iarg], "switchinnerflag") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + switchinnerflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; - } else if (strcmp(arg[iarg],"sinner") == 0) { + } else if (strcmp(arg[iarg], "sinner") == 0) { iarg++; - if (iarg+ntypes > narg) - error->all(FLERR,"Illegal compute snad/atom command"); - memory->create(sinnerelem,ntypes+1,"snad/atom:sinnerelem"); + if (iarg + ntypes > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + memory->create(sinnerelem, ntypes + 1, "snap:sinnerelem"); for (int i = 0; i < ntypes; i++) - sinnerelem[i+1] = utils::numeric(FLERR,arg[iarg+i],false,lmp); + sinnerelem[i + 1] = utils::numeric(FLERR, arg[iarg + i], false, lmp); sinnerflag = 1; iarg += ntypes; - } else if (strcmp(arg[iarg],"dinner") == 0) { + } else if (strcmp(arg[iarg], "dinner") == 0) { iarg++; - if (iarg+ntypes > narg) - error->all(FLERR,"Illegal compute snad/atom command"); - memory->create(dinnerelem,ntypes+1,"snad/atom:dinnerelem"); + if (iarg + ntypes > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + memory->create(dinnerelem, ntypes + 1, "snap:dinnerelem"); for (int i = 0; i < ntypes; i++) - dinnerelem[i+1] = utils::numeric(FLERR,arg[iarg+i],false,lmp); + dinnerelem[i + 1] = utils::numeric(FLERR, arg[iarg + i], false, lmp); dinnerflag = 1; iarg += ntypes; - } else error->all(FLERR,"Illegal compute snad/atom command"); + } else + error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); } if (switchinnerflag && !(sinnerflag && dinnerflag)) - error->all(FLERR,"Illegal compute snad/atom command: switchinnerflag = 1, missing sinner/dinner keyword"); + error->all( + FLERR, + "Illegal compute ", SNAPCOMPUTENAME, " command: switchinnerflag = 1, missing sinner/dinner keyword"); if (!switchinnerflag && (sinnerflag || dinnerflag)) - error->all(FLERR,"Illegal compute snad/atom command: switchinnerflag = 0, unexpected sinner/dinner keyword"); + error->all( + FLERR, + "Illegal compute ", SNAPCOMPUTENAME, " command: switchinnerflag = 0, unexpected sinner/dinner keyword"); - - snaptr = new SNA(lmp, rfac0, twojmax, - rmin0, switchflag, bzeroflag, - chemflag, bnormflag, wselfallflag, - nelements, switchinnerflag); + snaptr = new SNA(lmp, rfac0, twojmax, rmin0, switchflag, bzeroflag, chemflag, bnormflag, + wselfallflag, nelements, switchinnerflag); ncoeff = snaptr->ncoeff; - nperdim = ncoeff; - if (quadraticflag) nperdim += (ncoeff*(ncoeff+1))/2; - yoffset = nperdim; - zoffset = 2*nperdim; - size_peratom_cols = 3*nperdim*atom->ntypes; + nvalues = ncoeff; + if (quadraticflag) nvalues += (ncoeff * (ncoeff + 1)) / 2; + + // end code common to all SNAP computes + + yoffset = nvalues; + zoffset = 2*nvalues; + size_peratom_cols = 3*nvalues*atom->ntypes; comm_reverse = size_peratom_cols; peratom_flag = 1; @@ -289,7 +290,7 @@ void ComputeSNADAtom::compute_peratom() // const int typeoffset = threencoeff*(atom->type[i]-1); // const int quadraticoffset = threencoeff*atom->ntypes + // threencoeffq*(atom->type[i]-1); - const int typeoffset = 3*nperdim*(atom->type[i]-1); + const int typeoffset = 3*nvalues*(atom->type[i]-1); // insure rij, inside, and typej are of size jnum diff --git a/src/ML-SNAP/compute_snad_atom.h b/src/ML-SNAP/compute_snad_atom.h index 0cdb075daf..ac27e10769 100644 --- a/src/ML-SNAP/compute_snad_atom.h +++ b/src/ML-SNAP/compute_snad_atom.h @@ -37,7 +37,7 @@ class ComputeSNADAtom : public Compute { private: int nmax; - int ncoeff, nperdim, yoffset, zoffset; + int ncoeff, nvalues, yoffset, zoffset; double **cutsq; class NeighList *list; double **snad; diff --git a/src/ML-SNAP/compute_snap.cpp b/src/ML-SNAP/compute_snap.cpp index 83f56e338c..64daaa4c1e 100644 --- a/src/ML-SNAP/compute_snap.cpp +++ b/src/ML-SNAP/compute_snap.cpp @@ -32,6 +32,8 @@ using namespace LAMMPS_NS; enum{SCALAR,VECTOR,ARRAY}; +#define SNAPCOMPUTENAME "snap" + ComputeSnap::ComputeSnap(LAMMPS *lmp, int narg, char **arg) : Compute(lmp, narg, arg), cutsq(nullptr), list(nullptr), snap(nullptr), snapall(nullptr), snap_peratom(nullptr), radelem(nullptr), wjelem(nullptr), @@ -41,13 +43,15 @@ ComputeSnap::ComputeSnap(LAMMPS *lmp, int narg, char **arg) : array_flag = 1; extarray = 0; + // code common to all SNAP computes + double rfac0, rmin0; int twojmax, switchflag, bzeroflag, bnormflag, wselfallflag; int ntypes = atom->ntypes; - int nargmin = 6+2*ntypes; + int nargmin = 6 + 2 * ntypes; - if (narg < nargmin) error->all(FLERR,"Illegal compute snap command"); + if (narg < nargmin) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); // default values @@ -55,7 +59,6 @@ ComputeSnap::ComputeSnap(LAMMPS *lmp, int narg, char **arg) : switchflag = 1; bzeroflag = 1; quadraticflag = 0; - bikflag = 0; chemflag = 0; bnormflag = 0; wselfallflag = 0; @@ -64,28 +67,32 @@ ComputeSnap::ComputeSnap(LAMMPS *lmp, int narg, char **arg) : // process required arguments - memory->create(radelem,ntypes+1,"snap:radelem"); // offset by 1 to match up with types - memory->create(wjelem,ntypes+1,"snap:wjelem"); - rcutfac = atof(arg[3]); - rfac0 = atof(arg[4]); - twojmax = atoi(arg[5]); + memory->create(radelem, ntypes + 1, "snap:radelem"); // offset by 1 to match up with types + memory->create(wjelem, ntypes + 1, "snap:wjelem"); + + rcutfac = utils::numeric(FLERR, arg[3], false, lmp); + rfac0 = utils::numeric(FLERR, arg[4], false, lmp); + twojmax = utils::inumeric(FLERR, arg[5], false, lmp); + for (int i = 0; i < ntypes; i++) - radelem[i+1] = atof(arg[6+i]); + radelem[i + 1] = + utils::numeric(FLERR, arg[6 + i], false, lmp); for (int i = 0; i < ntypes; i++) - wjelem[i+1] = atof(arg[6+ntypes+i]); + wjelem[i + 1] = + utils::numeric(FLERR, arg[6 + ntypes + i], false, lmp); // construct cutsq double cut; cutmax = 0.0; - memory->create(cutsq,ntypes+1,ntypes+1,"snap:cutsq"); + memory->create(cutsq, ntypes + 1, ntypes + 1, "snap:cutsq"); for (int i = 1; i <= ntypes; i++) { - cut = 2.0*radelem[i]*rcutfac; + cut = 2.0 * radelem[i] * rcutfac; if (cut > cutmax) cutmax = cut; - cutsq[i][i] = cut*cut; - for (int j = i+1; j <= ntypes; j++) { - cut = (radelem[i]+radelem[j])*rcutfac; - cutsq[i][j] = cutsq[j][i] = cut*cut; + cutsq[i][i] = cut * cut; + for (int j = i + 1; j <= ntypes; j++) { + cut = (radelem[i] + radelem[j]) * rcutfac; + cutsq[i][j] = cutsq[j][i] = cut * cut; } } @@ -99,107 +106,97 @@ ComputeSnap::ComputeSnap(LAMMPS *lmp, int narg, char **arg) : int iarg = nargmin; while (iarg < narg) { - if (strcmp(arg[iarg],"rmin0") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute snap command"); - rmin0 = atof(arg[iarg+1]); + if (strcmp(arg[iarg], "rmin0") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + rmin0 = utils::numeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; - } else if (strcmp(arg[iarg],"bzeroflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute snap command"); - bzeroflag = atoi(arg[iarg+1]); + } else if (strcmp(arg[iarg], "switchflag") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + switchflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; - } else if (strcmp(arg[iarg],"switchflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute snap command"); - switchflag = atoi(arg[iarg+1]); + } else if (strcmp(arg[iarg], "bzeroflag") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + bzeroflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; - } else if (strcmp(arg[iarg],"quadraticflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute snap command"); - quadraticflag = atoi(arg[iarg+1]); + } else if (strcmp(arg[iarg], "quadraticflag") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + quadraticflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; - } else if (strcmp(arg[iarg],"chem") == 0) { - if (iarg+2+ntypes > narg) - error->all(FLERR,"Illegal compute snap command"); + } else if (strcmp(arg[iarg], "chem") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); chemflag = 1; - memory->create(map,ntypes+1,"compute_snap:map"); - nelements = utils::inumeric(FLERR,arg[iarg+1],false,lmp); + memory->create(map, ntypes + 1, "compute_sna_grid:map"); + nelements = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); for (int i = 0; i < ntypes; i++) { - int jelem = utils::inumeric(FLERR,arg[iarg+2+i],false,lmp); - if (jelem < 0 || jelem >= nelements) - error->all(FLERR,"Illegal compute snap command"); - map[i+1] = jelem; + int jelem = utils::inumeric(FLERR, arg[iarg + 2 + i], false, lmp); + if (jelem < 0 || jelem >= nelements) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + map[i + 1] = jelem; } - iarg += 2+ntypes; - } else if (strcmp(arg[iarg],"bnormflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute snap command"); - bnormflag = atoi(arg[iarg+1]); + iarg += 2 + ntypes; + } else if (strcmp(arg[iarg], "bnormflag") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + bnormflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; - } else if (strcmp(arg[iarg],"wselfallflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute snap command"); - wselfallflag = atoi(arg[iarg+1]); + } else if (strcmp(arg[iarg], "wselfallflag") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + wselfallflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; - } else if (strcmp(arg[iarg],"bikflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute snap command"); - bikflag = atoi(arg[iarg+1]); + } else if (strcmp(arg[iarg], "switchinnerflag") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + switchinnerflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; - } else if (strcmp(arg[iarg],"switchinnerflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute snap command"); - switchinnerflag = atoi(arg[iarg+1]); - iarg += 2; - } else if (strcmp(arg[iarg],"sinner") == 0) { + } else if (strcmp(arg[iarg], "sinner") == 0) { iarg++; - if (iarg+ntypes > narg) - error->all(FLERR,"Illegal compute snap command"); - memory->create(sinnerelem,ntypes+1,"snap:sinnerelem"); + if (iarg + ntypes > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + memory->create(sinnerelem, ntypes + 1, "snap:sinnerelem"); for (int i = 0; i < ntypes; i++) - sinnerelem[i+1] = utils::numeric(FLERR,arg[iarg+i],false,lmp); + sinnerelem[i + 1] = utils::numeric(FLERR, arg[iarg + i], false, lmp); sinnerflag = 1; iarg += ntypes; - } else if (strcmp(arg[iarg],"dinner") == 0) { + } else if (strcmp(arg[iarg], "dinner") == 0) { iarg++; - if (iarg+ntypes > narg) - error->all(FLERR,"Illegal compute snap command"); - memory->create(dinnerelem,ntypes+1,"snap:dinnerelem"); + if (iarg + ntypes > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + memory->create(dinnerelem, ntypes + 1, "snap:dinnerelem"); for (int i = 0; i < ntypes; i++) - dinnerelem[i+1] = utils::numeric(FLERR,arg[iarg+i],false,lmp); + dinnerelem[i + 1] = utils::numeric(FLERR, arg[iarg + i], false, lmp); dinnerflag = 1; iarg += ntypes; - } else error->all(FLERR,"Illegal compute snap command"); + } else + error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); } if (switchinnerflag && !(sinnerflag && dinnerflag)) - error->all(FLERR,"Illegal compute snap command: switchinnerflag = 1, missing sinner/dinner keyword"); + error->all( + FLERR, + "Illegal compute ", SNAPCOMPUTENAME, " command: switchinnerflag = 1, missing sinner/dinner keyword"); if (!switchinnerflag && (sinnerflag || dinnerflag)) - error->all(FLERR,"Illegal compute snap command: switchinnerflag = 0, unexpected sinner/dinner keyword"); + error->all( + FLERR, + "Illegal compute ", SNAPCOMPUTENAME, " command: switchinnerflag = 0, unexpected sinner/dinner keyword"); - snaptr = new SNA(lmp, rfac0, twojmax, - rmin0, switchflag, bzeroflag, - chemflag, bnormflag, wselfallflag, - nelements, switchinnerflag); + snaptr = new SNA(lmp, rfac0, twojmax, rmin0, switchflag, bzeroflag, chemflag, bnormflag, + wselfallflag, nelements, switchinnerflag); ncoeff = snaptr->ncoeff; - nperdim = ncoeff; - if (quadraticflag) nperdim += (ncoeff*(ncoeff+1))/2; + nvalues = ncoeff; + if (quadraticflag) nvalues += (ncoeff * (ncoeff + 1)) / 2; + + // end code common to all SNAP computes + ndims_force = 3; ndims_virial = 6; - yoffset = nperdim; - zoffset = 2*nperdim; + yoffset = nvalues; + zoffset = 2*nvalues; natoms = atom->natoms; bik_rows = 1; if (bikflag) bik_rows = natoms; size_array_rows = bik_rows+ndims_force*natoms+ndims_virial; - size_array_cols = nperdim*atom->ntypes+1; + size_array_cols = nvalues*atom->ntypes+1; lastcol = size_array_cols-1; ndims_peratom = ndims_force; - size_peratom = ndims_peratom*nperdim*atom->ntypes; + size_peratom = ndims_peratom*nvalues*atom->ntypes; nmax = 0; } @@ -341,8 +338,8 @@ void ComputeSnap::compute_array() const double radi = radelem[itype]; const int* const jlist = firstneigh[i]; const int jnum = numneigh[i]; - const int typeoffset_local = ndims_peratom*nperdim*(itype-1); - const int typeoffset_global = nperdim*(itype-1); + const int typeoffset_local = ndims_peratom*nvalues*(itype-1); + const int typeoffset_global = nvalues*(itype-1); // insure rij, inside, and typej are of size jnum @@ -481,9 +478,9 @@ void ComputeSnap::compute_array() // accumulate bispectrum force contributions to global array for (int itype = 0; itype < atom->ntypes; itype++) { - const int typeoffset_local = ndims_peratom*nperdim*itype; - const int typeoffset_global = nperdim*itype; - for (int icoeff = 0; icoeff < nperdim; icoeff++) { + const int typeoffset_local = ndims_peratom*nvalues*itype; + const int typeoffset_global = nvalues*itype; + for (int icoeff = 0; icoeff < nvalues; icoeff++) { for (int i = 0; i < ntotal; i++) { double *snadi = snap_peratom[i]+typeoffset_local; int iglobal = atom->tag[i]; @@ -549,10 +546,10 @@ void ComputeSnap::dbdotr_compute() int nall = atom->nlocal + atom->nghost; for (int i = 0; i < nall; i++) for (int itype = 0; itype < atom->ntypes; itype++) { - const int typeoffset_local = ndims_peratom*nperdim*itype; - const int typeoffset_global = nperdim*itype; + const int typeoffset_local = ndims_peratom*nvalues*itype; + const int typeoffset_global = nvalues*itype; double *snadi = snap_peratom[i]+typeoffset_local; - for (int icoeff = 0; icoeff < nperdim; icoeff++) { + for (int icoeff = 0; icoeff < nvalues; icoeff++) { double dbdx = snadi[icoeff]; double dbdy = snadi[icoeff+yoffset]; double dbdz = snadi[icoeff+zoffset]; diff --git a/src/ML-SNAP/compute_snap.h b/src/ML-SNAP/compute_snap.h index bc0670e2c7..9f4162d6c4 100644 --- a/src/ML-SNAP/compute_snap.h +++ b/src/ML-SNAP/compute_snap.h @@ -35,7 +35,7 @@ class ComputeSnap : public Compute { private: int natoms, nmax, size_peratom, lastcol; - int ncoeff, nperdim, yoffset, zoffset; + int ncoeff, nvalues, yoffset, zoffset; int ndims_peratom, ndims_force, ndims_virial; double **cutsq; class NeighList *list; diff --git a/src/ML-SNAP/compute_snav_atom.cpp b/src/ML-SNAP/compute_snav_atom.cpp index 0baa4bc110..b2fa24b231 100644 --- a/src/ML-SNAP/compute_snav_atom.cpp +++ b/src/ML-SNAP/compute_snav_atom.cpp @@ -21,6 +21,7 @@ #include "neighbor.h" #include "neigh_list.h" #include "force.h" +#include "pair.h" #include "comm.h" #include "memory.h" #include "error.h" @@ -29,24 +30,27 @@ using namespace LAMMPS_NS; +#define SNAPCOMPUTENAME "snav/atom" + ComputeSNAVAtom::ComputeSNAVAtom(LAMMPS *lmp, int narg, char **arg) : Compute(lmp, narg, arg), cutsq(nullptr), list(nullptr), snav(nullptr), radelem(nullptr), wjelem(nullptr), sinnerelem(nullptr), dinnerelem(nullptr) { + // code common to all SNAP computes + double rfac0, rmin0; int twojmax, switchflag, bzeroflag, bnormflag, wselfallflag; int ntypes = atom->ntypes; - int nargmin = 6+2*ntypes; + int nargmin = 6 + 2 * ntypes; - if (narg < nargmin) error->all(FLERR,"Illegal compute snav/atom command"); + if (narg < nargmin) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); // default values rmin0 = 0.0; switchflag = 1; bzeroflag = 1; - bnormflag = 0; quadraticflag = 0; chemflag = 0; bnormflag = 0; @@ -56,24 +60,32 @@ ComputeSNAVAtom::ComputeSNAVAtom(LAMMPS *lmp, int narg, char **arg) : // process required arguments - memory->create(radelem,ntypes+1,"snav/atom:radelem"); // offset by 1 to match up with types - memory->create(wjelem,ntypes+1,"snav/atom:wjelem"); - rcutfac = atof(arg[3]); - rfac0 = atof(arg[4]); - twojmax = atoi(arg[5]); + memory->create(radelem, ntypes + 1, "snav/atom:radelem"); // offset by 1 to match up with types + memory->create(wjelem, ntypes + 1, "snav/atom:wjelem"); + + rcutfac = utils::numeric(FLERR, arg[3], false, lmp); + rfac0 = utils::numeric(FLERR, arg[4], false, lmp); + twojmax = utils::inumeric(FLERR, arg[5], false, lmp); + for (int i = 0; i < ntypes; i++) - radelem[i+1] = atof(arg[6+i]); + radelem[i + 1] = + utils::numeric(FLERR, arg[6 + i], false, lmp); for (int i = 0; i < ntypes; i++) - wjelem[i+1] = atof(arg[6+ntypes+i]); + wjelem[i + 1] = + utils::numeric(FLERR, arg[6 + ntypes + i], false, lmp); + // construct cutsq + double cut; - memory->create(cutsq,ntypes+1,ntypes+1,"snav/atom:cutsq"); + cutmax = 0.0; + memory->create(cutsq, ntypes + 1, ntypes + 1, "snav/atom:cutsq"); for (int i = 1; i <= ntypes; i++) { - cut = 2.0*radelem[i]*rcutfac; - cutsq[i][i] = cut*cut; - for (int j = i+1; j <= ntypes; j++) { - cut = (radelem[i]+radelem[j])*rcutfac; - cutsq[i][j] = cutsq[j][i] = cut*cut; + cut = 2.0 * radelem[i] * rcutfac; + if (cut > cutmax) cutmax = cut; + cutsq[i][i] = cut * cut; + for (int j = i + 1; j <= ntypes; j++) { + cut = (radelem[i] + radelem[j]) * rcutfac; + cutsq[i][j] = cutsq[j][i] = cut * cut; } } @@ -87,90 +99,85 @@ ComputeSNAVAtom::ComputeSNAVAtom(LAMMPS *lmp, int narg, char **arg) : int iarg = nargmin; while (iarg < narg) { - if (strcmp(arg[iarg],"rmin0") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute snav/atom command"); - rmin0 = atof(arg[iarg+1]); + if (strcmp(arg[iarg], "rmin0") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + rmin0 = utils::numeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; - } else if (strcmp(arg[iarg],"switchflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute snav/atom command"); - switchflag = atoi(arg[iarg+1]); + } else if (strcmp(arg[iarg], "switchflag") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + switchflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; - } else if (strcmp(arg[iarg],"bzeroflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute snav/atom command"); - bzeroflag = atoi(arg[iarg+1]); + } else if (strcmp(arg[iarg], "bzeroflag") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + bzeroflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; - } else if (strcmp(arg[iarg],"quadraticflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute snav/atom command"); - quadraticflag = atoi(arg[iarg+1]); + } else if (strcmp(arg[iarg], "quadraticflag") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + quadraticflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; - } else if (strcmp(arg[iarg],"chem") == 0) { - if (iarg+2+ntypes > narg) - error->all(FLERR,"Illegal compute snav/atom command"); + } else if (strcmp(arg[iarg], "chem") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); chemflag = 1; - memory->create(map,ntypes+1,"compute_sna_atom:map"); - nelements = utils::inumeric(FLERR,arg[iarg+1],false,lmp); + memory->create(map, ntypes + 1, "compute_sna_grid:map"); + nelements = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); for (int i = 0; i < ntypes; i++) { - int jelem = utils::inumeric(FLERR,arg[iarg+2+i],false,lmp); - if (jelem < 0 || jelem >= nelements) - error->all(FLERR,"Illegal compute snav/atom command"); - map[i+1] = jelem; + int jelem = utils::inumeric(FLERR, arg[iarg + 2 + i], false, lmp); + if (jelem < 0 || jelem >= nelements) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + map[i + 1] = jelem; } - iarg += 2+ntypes; - } else if (strcmp(arg[iarg],"bnormflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute snav/atom command"); - bnormflag = atoi(arg[iarg+1]); + iarg += 2 + ntypes; + } else if (strcmp(arg[iarg], "bnormflag") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + bnormflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; - } else if (strcmp(arg[iarg],"wselfallflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute snav/atom command"); - wselfallflag = atoi(arg[iarg+1]); + } else if (strcmp(arg[iarg], "wselfallflag") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + wselfallflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; - } else if (strcmp(arg[iarg],"switchinnerflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute snav/atom command"); - switchinnerflag = atoi(arg[iarg+1]); + } else if (strcmp(arg[iarg], "switchinnerflag") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + switchinnerflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; - } else if (strcmp(arg[iarg],"sinner") == 0) { + } else if (strcmp(arg[iarg], "sinner") == 0) { iarg++; - if (iarg+ntypes > narg) - error->all(FLERR,"Illegal compute snav/atom command"); - memory->create(sinnerelem,ntypes+1,"snav/atom:sinnerelem"); + if (iarg + ntypes > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + memory->create(sinnerelem, ntypes + 1, "snap:sinnerelem"); for (int i = 0; i < ntypes; i++) - sinnerelem[i+1] = utils::numeric(FLERR,arg[iarg+i],false,lmp); + sinnerelem[i + 1] = utils::numeric(FLERR, arg[iarg + i], false, lmp); sinnerflag = 1; iarg += ntypes; - } else if (strcmp(arg[iarg],"dinner") == 0) { + } else if (strcmp(arg[iarg], "dinner") == 0) { iarg++; - if (iarg+ntypes > narg) - error->all(FLERR,"Illegal compute snav/atom command"); - memory->create(dinnerelem,ntypes+1,"snav/atom:dinnerelem"); + if (iarg + ntypes > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + memory->create(dinnerelem, ntypes + 1, "snap:dinnerelem"); for (int i = 0; i < ntypes; i++) - dinnerelem[i+1] = utils::numeric(FLERR,arg[iarg+i],false,lmp); + dinnerelem[i + 1] = utils::numeric(FLERR, arg[iarg + i], false, lmp); dinnerflag = 1; iarg += ntypes; - } else error->all(FLERR,"Illegal compute snav/atom command"); + } else + error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); } if (switchinnerflag && !(sinnerflag && dinnerflag)) - error->all(FLERR,"Illegal compute snav/atom command: switchinnerflag = 1, missing sinner/dinner keyword"); + error->all( + FLERR, + "Illegal compute ", SNAPCOMPUTENAME, " command: switchinnerflag = 1, missing sinner/dinner keyword"); if (!switchinnerflag && (sinnerflag || dinnerflag)) - error->all(FLERR,"Illegal compute snav/atom command: switchinnerflag = 0, unexpected sinner/dinner keyword"); + error->all( + FLERR, + "Illegal compute ", SNAPCOMPUTENAME, " command: switchinnerflag = 0, unexpected sinner/dinner keyword"); - snaptr = new SNA(lmp, rfac0, twojmax, - rmin0, switchflag, bzeroflag, - chemflag, bnormflag, wselfallflag, - nelements, switchinnerflag); + snaptr = new SNA(lmp, rfac0, twojmax, rmin0, switchflag, bzeroflag, chemflag, bnormflag, + wselfallflag, nelements, switchinnerflag); ncoeff = snaptr->ncoeff; - nperdim = ncoeff; - if (quadraticflag) nperdim += (ncoeff*(ncoeff+1))/2; - size_peratom_cols = 6*nperdim*atom->ntypes; + nvalues = ncoeff; + if (quadraticflag) nvalues += (ncoeff * (ncoeff + 1)) / 2; + + // end code common to all SNAP computes + + size_peratom_cols = 6*nvalues*atom->ntypes; comm_reverse = size_peratom_cols; peratom_flag = 1; @@ -203,10 +210,9 @@ void ComputeSNAVAtom::init() { if (force->pair == nullptr) error->all(FLERR,"Compute snav/atom requires a pair style be defined"); - // TODO: Not sure what to do with this error check since cutoff radius is not - // a single number - //if (sqrt(cutsq) > force->pair->cutforce) - // error->all(FLERR,"Compute snav/atom cutoff is longer than pairwise cutoff"); + + if (cutmax > force->pair->cutforce) + error->all(FLERR,"Compute snav/atom cutoff is longer than pairwise cutoff"); // need an occasional full neighbor list @@ -280,7 +286,7 @@ void ComputeSNAVAtom::compute_peratom() const int* const jlist = firstneigh[i]; const int jnum = numneigh[i]; - const int typeoffset = 6*nperdim*(atom->type[i]-1); + const int typeoffset = 6*nvalues*(atom->type[i]-1); // insure rij, inside, and typej are of size jnum @@ -339,17 +345,17 @@ void ComputeSNAVAtom::compute_peratom() for (int icoeff = 0; icoeff < ncoeff; icoeff++) { snavi[icoeff] += snaptr->dblist[icoeff][0]*xtmp; - snavi[icoeff+nperdim] += snaptr->dblist[icoeff][1]*ytmp; - snavi[icoeff+2*nperdim] += snaptr->dblist[icoeff][2]*ztmp; - snavi[icoeff+3*nperdim] += snaptr->dblist[icoeff][1]*ztmp; - snavi[icoeff+4*nperdim] += snaptr->dblist[icoeff][0]*ztmp; - snavi[icoeff+5*nperdim] += snaptr->dblist[icoeff][0]*ytmp; + snavi[icoeff+nvalues] += snaptr->dblist[icoeff][1]*ytmp; + snavi[icoeff+2*nvalues] += snaptr->dblist[icoeff][2]*ztmp; + snavi[icoeff+3*nvalues] += snaptr->dblist[icoeff][1]*ztmp; + snavi[icoeff+4*nvalues] += snaptr->dblist[icoeff][0]*ztmp; + snavi[icoeff+5*nvalues] += snaptr->dblist[icoeff][0]*ytmp; snavj[icoeff] -= snaptr->dblist[icoeff][0]*x[j][0]; - snavj[icoeff+nperdim] -= snaptr->dblist[icoeff][1]*x[j][1]; - snavj[icoeff+2*nperdim] -= snaptr->dblist[icoeff][2]*x[j][2]; - snavj[icoeff+3*nperdim] -= snaptr->dblist[icoeff][1]*x[j][2]; - snavj[icoeff+4*nperdim] -= snaptr->dblist[icoeff][0]*x[j][2]; - snavj[icoeff+5*nperdim] -= snaptr->dblist[icoeff][0]*x[j][1]; + snavj[icoeff+nvalues] -= snaptr->dblist[icoeff][1]*x[j][1]; + snavj[icoeff+2*nvalues] -= snaptr->dblist[icoeff][2]*x[j][2]; + snavj[icoeff+3*nvalues] -= snaptr->dblist[icoeff][1]*x[j][2]; + snavj[icoeff+4*nvalues] -= snaptr->dblist[icoeff][0]*x[j][2]; + snavj[icoeff+5*nvalues] -= snaptr->dblist[icoeff][0]*x[j][1]; } if (quadraticflag) { @@ -369,17 +375,17 @@ void ComputeSNAVAtom::compute_peratom() double dbytmp = bi*biy; double dbztmp = bi*biz; snavi[ncount] += dbxtmp*xtmp; - snavi[ncount+nperdim] += dbytmp*ytmp; - snavi[ncount+2*nperdim] += dbztmp*ztmp; - snavi[ncount+3*nperdim] += dbytmp*ztmp; - snavi[ncount+4*nperdim] += dbxtmp*ztmp; - snavi[ncount+5*nperdim] += dbxtmp*ytmp; + snavi[ncount+nvalues] += dbytmp*ytmp; + snavi[ncount+2*nvalues] += dbztmp*ztmp; + snavi[ncount+3*nvalues] += dbytmp*ztmp; + snavi[ncount+4*nvalues] += dbxtmp*ztmp; + snavi[ncount+5*nvalues] += dbxtmp*ytmp; snavj[ncount] -= dbxtmp*x[j][0]; - snavj[ncount+nperdim] -= dbytmp*x[j][1]; - snavj[ncount+2*nperdim] -= dbztmp*x[j][2]; - snavj[ncount+3*nperdim] -= dbytmp*x[j][2]; - snavj[ncount+4*nperdim] -= dbxtmp*x[j][2]; - snavj[ncount+5*nperdim] -= dbxtmp*x[j][1]; + snavj[ncount+nvalues] -= dbytmp*x[j][1]; + snavj[ncount+2*nvalues] -= dbztmp*x[j][2]; + snavj[ncount+3*nvalues] -= dbytmp*x[j][2]; + snavj[ncount+4*nvalues] -= dbxtmp*x[j][2]; + snavj[ncount+5*nvalues] -= dbxtmp*x[j][1]; ncount++; // upper-triangular elements of quadratic matrix @@ -392,17 +398,17 @@ void ComputeSNAVAtom::compute_peratom() double dbztmp = bi*snaptr->dblist[jcoeff][2] + biz*snaptr->blist[jcoeff]; snavi[ncount] += dbxtmp*xtmp; - snavi[ncount+nperdim] += dbytmp*ytmp; - snavi[ncount+2*nperdim] += dbztmp*ztmp; - snavi[ncount+3*nperdim] += dbytmp*ztmp; - snavi[ncount+4*nperdim] += dbxtmp*ztmp; - snavi[ncount+5*nperdim] += dbxtmp*ytmp; + snavi[ncount+nvalues] += dbytmp*ytmp; + snavi[ncount+2*nvalues] += dbztmp*ztmp; + snavi[ncount+3*nvalues] += dbytmp*ztmp; + snavi[ncount+4*nvalues] += dbxtmp*ztmp; + snavi[ncount+5*nvalues] += dbxtmp*ytmp; snavj[ncount] -= dbxtmp*x[j][0]; - snavj[ncount+nperdim] -= dbytmp*x[j][1]; - snavj[ncount+2*nperdim] -= dbztmp*x[j][2]; - snavj[ncount+3*nperdim] -= dbytmp*x[j][2]; - snavj[ncount+4*nperdim] -= dbxtmp*x[j][2]; - snavj[ncount+5*nperdim] -= dbxtmp*x[j][1]; + snavj[ncount+nvalues] -= dbytmp*x[j][1]; + snavj[ncount+2*nvalues] -= dbztmp*x[j][2]; + snavj[ncount+3*nvalues] -= dbytmp*x[j][2]; + snavj[ncount+4*nvalues] -= dbxtmp*x[j][2]; + snavj[ncount+5*nvalues] -= dbxtmp*x[j][1]; ncount++; } } diff --git a/src/ML-SNAP/compute_snav_atom.h b/src/ML-SNAP/compute_snav_atom.h index 1eb84d8df7..2eac0b7b28 100644 --- a/src/ML-SNAP/compute_snav_atom.h +++ b/src/ML-SNAP/compute_snav_atom.h @@ -37,7 +37,7 @@ class ComputeSNAVAtom : public Compute { private: int nmax; - int ncoeff, nperdim; + int ncoeff, nvalues; double **cutsq; class NeighList *list; double **snav; @@ -50,6 +50,7 @@ class ComputeSNAVAtom : public Compute { double *sinnerelem; double *dinnerelem; class SNA *snaptr; + double cutmax; int quadraticflag; }; From 3ff998fdb0bff166355eeb2b61694b1a4ecc359d Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Fri, 17 Jun 2022 17:31:58 -0600 Subject: [PATCH 399/585] Restricted style string matching --- src/ML-SNAP/compute_sna_grid.cpp | 2 +- src/ML-SNAP/compute_sna_grid_local.cpp | 2 +- 2 files changed, 2 insertions(+), 2 deletions(-) diff --git a/src/ML-SNAP/compute_sna_grid.cpp b/src/ML-SNAP/compute_sna_grid.cpp index 4c8e4f82ef..2a9b9bf672 100644 --- a/src/ML-SNAP/compute_sna_grid.cpp +++ b/src/ML-SNAP/compute_sna_grid.cpp @@ -200,7 +200,7 @@ ComputeSNAGrid::~ComputeSNAGrid() void ComputeSNAGrid::init() { - if ((modify->get_compute_by_style("sna/grid").size() > 1) && (comm->me == 0)) + if ((modify->get_compute_by_style("^sna/grid$").size() > 1) && (comm->me == 0)) error->warning(FLERR, "More than one instance of compute sna/grid"); snaptr->init(); } diff --git a/src/ML-SNAP/compute_sna_grid_local.cpp b/src/ML-SNAP/compute_sna_grid_local.cpp index d9d66787f4..aa18d4c84d 100644 --- a/src/ML-SNAP/compute_sna_grid_local.cpp +++ b/src/ML-SNAP/compute_sna_grid_local.cpp @@ -199,7 +199,7 @@ ComputeSNAGridLocal::~ComputeSNAGridLocal() void ComputeSNAGridLocal::init() { - if ((modify->get_compute_by_style("sna/grid/local").size() > 1) && (comm->me == 0)) + if ((modify->get_compute_by_style("^sna/grid/local$").size() > 1) && (comm->me == 0)) error->warning(FLERR, "More than one instance of compute sna/grid/local"); snaptr->init(); } From cbc7669a4f43a4e7180444afbd00311c554de857 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 17 Jun 2022 19:37:26 -0400 Subject: [PATCH 400/585] apply clang-format --- src/ML-SNAP/compute_sna_grid.cpp | 22 +++++++++------------- src/ML-SNAP/compute_sna_grid_local.cpp | 23 ++++++++++------------- 2 files changed, 19 insertions(+), 26 deletions(-) diff --git a/src/ML-SNAP/compute_sna_grid.cpp b/src/ML-SNAP/compute_sna_grid.cpp index 2a9b9bf672..90df726687 100644 --- a/src/ML-SNAP/compute_sna_grid.cpp +++ b/src/ML-SNAP/compute_sna_grid.cpp @@ -63,19 +63,16 @@ ComputeSNAGrid::ComputeSNAGrid(LAMMPS *lmp, int narg, char **arg) : // process required arguments - memory->create(radelem, ntypes + 1, "sna/grid:radelem"); // offset by 1 to match up with types + memory->create(radelem, ntypes + 1, "sna/grid:radelem"); // offset by 1 to match up with types memory->create(wjelem, ntypes + 1, "sna/grid:wjelem"); rcutfac = utils::numeric(FLERR, arg[3], false, lmp); rfac0 = utils::numeric(FLERR, arg[4], false, lmp); twojmax = utils::inumeric(FLERR, arg[5], false, lmp); + for (int i = 0; i < ntypes; i++) radelem[i + 1] = utils::numeric(FLERR, arg[6 + i], false, lmp); for (int i = 0; i < ntypes; i++) - radelem[i + 1] = - utils::numeric(FLERR, arg[6 + i], false, lmp); - for (int i = 0; i < ntypes; i++) - wjelem[i + 1] = - utils::numeric(FLERR, arg[6 + ntypes + i], false, lmp); + wjelem[i + 1] = utils::numeric(FLERR, arg[6 + ntypes + i], false, lmp); // construct cutsq @@ -125,7 +122,8 @@ ComputeSNAGrid::ComputeSNAGrid(LAMMPS *lmp, int narg, char **arg) : nelements = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); for (int i = 0; i < ntypes; i++) { int jelem = utils::inumeric(FLERR, arg[iarg + 2 + i], false, lmp); - if (jelem < 0 || jelem >= nelements) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (jelem < 0 || jelem >= nelements) + error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); map[i + 1] = jelem; } iarg += 2 + ntypes; @@ -162,14 +160,12 @@ ComputeSNAGrid::ComputeSNAGrid(LAMMPS *lmp, int narg, char **arg) : } if (switchinnerflag && !(sinnerflag && dinnerflag)) - error->all( - FLERR, - "Illegal compute ", SNAPCOMPUTENAME, " command: switchinnerflag = 1, missing sinner/dinner keyword"); + error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, + " command: switchinnerflag = 1, missing sinner/dinner keyword"); if (!switchinnerflag && (sinnerflag || dinnerflag)) - error->all( - FLERR, - "Illegal compute ", SNAPCOMPUTENAME, " command: switchinnerflag = 0, unexpected sinner/dinner keyword"); + error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, + " command: switchinnerflag = 0, unexpected sinner/dinner keyword"); snaptr = new SNA(lmp, rfac0, twojmax, rmin0, switchflag, bzeroflag, chemflag, bnormflag, wselfallflag, nelements, switchinnerflag); diff --git a/src/ML-SNAP/compute_sna_grid_local.cpp b/src/ML-SNAP/compute_sna_grid_local.cpp index aa18d4c84d..3da5ef4e8a 100644 --- a/src/ML-SNAP/compute_sna_grid_local.cpp +++ b/src/ML-SNAP/compute_sna_grid_local.cpp @@ -63,19 +63,17 @@ ComputeSNAGridLocal::ComputeSNAGridLocal(LAMMPS *lmp, int narg, char **arg) : // process required arguments - memory->create(radelem, ntypes + 1, "sna/grid/local:radelem"); // offset by 1 to match up with types + memory->create(radelem, ntypes + 1, + "sna/grid/local:radelem"); // offset by 1 to match up with types memory->create(wjelem, ntypes + 1, "sna/grid/local:wjelem"); rcutfac = utils::numeric(FLERR, arg[3], false, lmp); rfac0 = utils::numeric(FLERR, arg[4], false, lmp); twojmax = utils::inumeric(FLERR, arg[5], false, lmp); + for (int i = 0; i < ntypes; i++) radelem[i + 1] = utils::numeric(FLERR, arg[6 + i], false, lmp); for (int i = 0; i < ntypes; i++) - radelem[i + 1] = - utils::numeric(FLERR, arg[6 + i], false, lmp); - for (int i = 0; i < ntypes; i++) - wjelem[i + 1] = - utils::numeric(FLERR, arg[6 + ntypes + i], false, lmp); + wjelem[i + 1] = utils::numeric(FLERR, arg[6 + ntypes + i], false, lmp); // construct cutsq @@ -125,7 +123,8 @@ ComputeSNAGridLocal::ComputeSNAGridLocal(LAMMPS *lmp, int narg, char **arg) : nelements = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); for (int i = 0; i < ntypes; i++) { int jelem = utils::inumeric(FLERR, arg[iarg + 2 + i], false, lmp); - if (jelem < 0 || jelem >= nelements) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (jelem < 0 || jelem >= nelements) + error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); map[i + 1] = jelem; } iarg += 2 + ntypes; @@ -162,14 +161,12 @@ ComputeSNAGridLocal::ComputeSNAGridLocal(LAMMPS *lmp, int narg, char **arg) : } if (switchinnerflag && !(sinnerflag && dinnerflag)) - error->all( - FLERR, - "Illegal compute ", SNAPCOMPUTENAME, " command: switchinnerflag = 1, missing sinner/dinner keyword"); + error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, + " command: switchinnerflag = 1, missing sinner/dinner keyword"); if (!switchinnerflag && (sinnerflag || dinnerflag)) - error->all( - FLERR, - "Illegal compute ", SNAPCOMPUTENAME, " command: switchinnerflag = 0, unexpected sinner/dinner keyword"); + error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, + " command: switchinnerflag = 0, unexpected sinner/dinner keyword"); snaptr = new SNA(lmp, rfac0, twojmax, rmin0, switchflag, bzeroflag, chemflag, bnormflag, wselfallflag, nelements, switchinnerflag); From 34e7fa92ab1f0d0b85845d34e22e24515ec7e9af Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 17 Jun 2022 19:44:13 -0400 Subject: [PATCH 401/585] simplify using fmt --- src/ML-SNAP/compute_sna_atom.cpp | 32 ++++++++++----------- src/ML-SNAP/compute_sna_grid.cpp | 39 +++++++++++++------------- src/ML-SNAP/compute_sna_grid_local.cpp | 39 +++++++++++++------------- src/ML-SNAP/compute_snad_atom.cpp | 32 ++++++++++----------- src/ML-SNAP/compute_snap.cpp | 32 ++++++++++----------- src/ML-SNAP/compute_snav_atom.cpp | 32 ++++++++++----------- 6 files changed, 98 insertions(+), 108 deletions(-) diff --git a/src/ML-SNAP/compute_sna_atom.cpp b/src/ML-SNAP/compute_sna_atom.cpp index 69f233b1c3..daec59e3f0 100644 --- a/src/ML-SNAP/compute_sna_atom.cpp +++ b/src/ML-SNAP/compute_sna_atom.cpp @@ -30,8 +30,6 @@ using namespace LAMMPS_NS; -#define SNAPCOMPUTENAME "sna/atom" - ComputeSNAAtom::ComputeSNAAtom(LAMMPS *lmp, int narg, char **arg) : Compute(lmp, narg, arg), cutsq(nullptr), list(nullptr), sna(nullptr), radelem(nullptr), wjelem(nullptr), sinnerelem(nullptr), dinnerelem(nullptr) @@ -45,7 +43,7 @@ ComputeSNAAtom::ComputeSNAAtom(LAMMPS *lmp, int narg, char **arg) : int ntypes = atom->ntypes; int nargmin = 6 + 2 * ntypes; - if (narg < nargmin) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (narg < nargmin) error->all(FLERR, "Illegal compute {} command", style); // default values @@ -101,47 +99,47 @@ ComputeSNAAtom::ComputeSNAAtom(LAMMPS *lmp, int narg, char **arg) : while (iarg < narg) { if (strcmp(arg[iarg], "rmin0") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); rmin0 = utils::numeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "switchflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); switchflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "bzeroflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); bzeroflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "quadraticflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); quadraticflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "chem") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); chemflag = 1; memory->create(map, ntypes + 1, "compute_sna_grid:map"); nelements = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); for (int i = 0; i < ntypes; i++) { int jelem = utils::inumeric(FLERR, arg[iarg + 2 + i], false, lmp); - if (jelem < 0 || jelem >= nelements) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (jelem < 0 || jelem >= nelements) error->all(FLERR, "Illegal compute {} command", style); map[i + 1] = jelem; } iarg += 2 + ntypes; } else if (strcmp(arg[iarg], "bnormflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); bnormflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "wselfallflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); wselfallflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "switchinnerflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); switchinnerflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "sinner") == 0) { iarg++; - if (iarg + ntypes > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + ntypes > narg) error->all(FLERR, "Illegal compute {} command", style); memory->create(sinnerelem, ntypes + 1, "snap:sinnerelem"); for (int i = 0; i < ntypes; i++) sinnerelem[i + 1] = utils::numeric(FLERR, arg[iarg + i], false, lmp); @@ -149,25 +147,25 @@ ComputeSNAAtom::ComputeSNAAtom(LAMMPS *lmp, int narg, char **arg) : iarg += ntypes; } else if (strcmp(arg[iarg], "dinner") == 0) { iarg++; - if (iarg + ntypes > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + ntypes > narg) error->all(FLERR, "Illegal compute {} command", style); memory->create(dinnerelem, ntypes + 1, "snap:dinnerelem"); for (int i = 0; i < ntypes; i++) dinnerelem[i + 1] = utils::numeric(FLERR, arg[iarg + i], false, lmp); dinnerflag = 1; iarg += ntypes; } else - error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + error->all(FLERR, "Illegal compute {} command", style); } if (switchinnerflag && !(sinnerflag && dinnerflag)) error->all( FLERR, - "Illegal compute ", SNAPCOMPUTENAME, " command: switchinnerflag = 1, missing sinner/dinner keyword"); + "Illegal compute {} command:, style switchinnerflag = 1, missing sinner/dinner keyword"); if (!switchinnerflag && (sinnerflag || dinnerflag)) error->all( FLERR, - "Illegal compute ", SNAPCOMPUTENAME, " command: switchinnerflag = 0, unexpected sinner/dinner keyword"); + "Illegal compute {} command:, style switchinnerflag = 0, unexpected sinner/dinner keyword"); snaptr = new SNA(lmp, rfac0, twojmax, rmin0, switchflag, bzeroflag, chemflag, bnormflag, wselfallflag, nelements, switchinnerflag); diff --git a/src/ML-SNAP/compute_sna_grid.cpp b/src/ML-SNAP/compute_sna_grid.cpp index 90df726687..f8da915051 100644 --- a/src/ML-SNAP/compute_sna_grid.cpp +++ b/src/ML-SNAP/compute_sna_grid.cpp @@ -27,8 +27,6 @@ using namespace LAMMPS_NS; -#define SNAPCOMPUTENAME "sna/grid" - ComputeSNAGrid::ComputeSNAGrid(LAMMPS *lmp, int narg, char **arg) : ComputeGrid(lmp, narg, arg), cutsq(nullptr), radelem(nullptr), wjelem(nullptr) { @@ -47,7 +45,7 @@ ComputeSNAGrid::ComputeSNAGrid(LAMMPS *lmp, int narg, char **arg) : int ntypes = atom->ntypes; int nargmin = 6 + 2 * ntypes; - if (narg < nargmin) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (narg < nargmin) error->all(FLERR, "Illegal compute {} command", style); // default values @@ -100,48 +98,47 @@ ComputeSNAGrid::ComputeSNAGrid(LAMMPS *lmp, int narg, char **arg) : while (iarg < narg) { if (strcmp(arg[iarg], "rmin0") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); rmin0 = utils::numeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "switchflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); switchflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "bzeroflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); bzeroflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "quadraticflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); quadraticflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "chem") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); chemflag = 1; memory->create(map, ntypes + 1, "compute_sna_grid:map"); nelements = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); for (int i = 0; i < ntypes; i++) { int jelem = utils::inumeric(FLERR, arg[iarg + 2 + i], false, lmp); - if (jelem < 0 || jelem >= nelements) - error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (jelem < 0 || jelem >= nelements) error->all(FLERR, "Illegal compute {} command", style); map[i + 1] = jelem; } iarg += 2 + ntypes; } else if (strcmp(arg[iarg], "bnormflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); bnormflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "wselfallflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); wselfallflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "switchinnerflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); switchinnerflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "sinner") == 0) { iarg++; - if (iarg + ntypes > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + ntypes > narg) error->all(FLERR, "Illegal compute {} command", style); memory->create(sinnerelem, ntypes + 1, "snap:sinnerelem"); for (int i = 0; i < ntypes; i++) sinnerelem[i + 1] = utils::numeric(FLERR, arg[iarg + i], false, lmp); @@ -149,23 +146,25 @@ ComputeSNAGrid::ComputeSNAGrid(LAMMPS *lmp, int narg, char **arg) : iarg += ntypes; } else if (strcmp(arg[iarg], "dinner") == 0) { iarg++; - if (iarg + ntypes > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + ntypes > narg) error->all(FLERR, "Illegal compute {} command", style); memory->create(dinnerelem, ntypes + 1, "snap:dinnerelem"); for (int i = 0; i < ntypes; i++) dinnerelem[i + 1] = utils::numeric(FLERR, arg[iarg + i], false, lmp); dinnerflag = 1; iarg += ntypes; } else - error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + error->all(FLERR, "Illegal compute {} command", style); } if (switchinnerflag && !(sinnerflag && dinnerflag)) - error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, - " command: switchinnerflag = 1, missing sinner/dinner keyword"); + error->all(FLERR, + "Illegal compute {} command: switchinnerflag = 1, missing sinner/dinner keyword", + style); if (!switchinnerflag && (sinnerflag || dinnerflag)) - error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, - " command: switchinnerflag = 0, unexpected sinner/dinner keyword"); + error->all(FLERR, + "Illegal compute {} command: switchinnerflag = 0, unexpected sinner/dinner keyword", + style); snaptr = new SNA(lmp, rfac0, twojmax, rmin0, switchflag, bzeroflag, chemflag, bnormflag, wselfallflag, nelements, switchinnerflag); diff --git a/src/ML-SNAP/compute_sna_grid_local.cpp b/src/ML-SNAP/compute_sna_grid_local.cpp index 3da5ef4e8a..079ecac319 100644 --- a/src/ML-SNAP/compute_sna_grid_local.cpp +++ b/src/ML-SNAP/compute_sna_grid_local.cpp @@ -27,8 +27,6 @@ using namespace LAMMPS_NS; -#define SNAPCOMPUTENAME "sna/grid/local" - ComputeSNAGridLocal::ComputeSNAGridLocal(LAMMPS *lmp, int narg, char **arg) : ComputeGridLocal(lmp, narg, arg), cutsq(nullptr), radelem(nullptr), wjelem(nullptr) { @@ -47,7 +45,7 @@ ComputeSNAGridLocal::ComputeSNAGridLocal(LAMMPS *lmp, int narg, char **arg) : int ntypes = atom->ntypes; int nargmin = 6 + 2 * ntypes; - if (narg < nargmin) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (narg < nargmin) error->all(FLERR, "Illegal compute {} command", style); // default values @@ -101,48 +99,47 @@ ComputeSNAGridLocal::ComputeSNAGridLocal(LAMMPS *lmp, int narg, char **arg) : while (iarg < narg) { if (strcmp(arg[iarg], "rmin0") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); rmin0 = utils::numeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "switchflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); switchflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "bzeroflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); bzeroflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "quadraticflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); quadraticflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "chem") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); chemflag = 1; memory->create(map, ntypes + 1, "compute_sna_grid:map"); nelements = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); for (int i = 0; i < ntypes; i++) { int jelem = utils::inumeric(FLERR, arg[iarg + 2 + i], false, lmp); - if (jelem < 0 || jelem >= nelements) - error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (jelem < 0 || jelem >= nelements) error->all(FLERR, "Illegal compute {} command", style); map[i + 1] = jelem; } iarg += 2 + ntypes; } else if (strcmp(arg[iarg], "bnormflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); bnormflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "wselfallflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); wselfallflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "switchinnerflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); switchinnerflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "sinner") == 0) { iarg++; - if (iarg + ntypes > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + ntypes > narg) error->all(FLERR, "Illegal compute {} command", style); memory->create(sinnerelem, ntypes + 1, "snap:sinnerelem"); for (int i = 0; i < ntypes; i++) sinnerelem[i + 1] = utils::numeric(FLERR, arg[iarg + i], false, lmp); @@ -150,23 +147,25 @@ ComputeSNAGridLocal::ComputeSNAGridLocal(LAMMPS *lmp, int narg, char **arg) : iarg += ntypes; } else if (strcmp(arg[iarg], "dinner") == 0) { iarg++; - if (iarg + ntypes > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + ntypes > narg) error->all(FLERR, "Illegal compute {} command", style); memory->create(dinnerelem, ntypes + 1, "snap:dinnerelem"); for (int i = 0; i < ntypes; i++) dinnerelem[i + 1] = utils::numeric(FLERR, arg[iarg + i], false, lmp); dinnerflag = 1; iarg += ntypes; } else - error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + error->all(FLERR, "Illegal compute {} command", style); } if (switchinnerflag && !(sinnerflag && dinnerflag)) - error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, - " command: switchinnerflag = 1, missing sinner/dinner keyword"); + error->all(FLERR, + "Illegal compute {} command: switchinnerflag = 1, missing sinner/dinner keyword", + style); if (!switchinnerflag && (sinnerflag || dinnerflag)) - error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, - " command: switchinnerflag = 0, unexpected sinner/dinner keyword"); + error->all(FLERR, + "Illegal compute {} command: switchinnerflag = 0, unexpected sinner/dinner keyword", + style); snaptr = new SNA(lmp, rfac0, twojmax, rmin0, switchflag, bzeroflag, chemflag, bnormflag, wselfallflag, nelements, switchinnerflag); diff --git a/src/ML-SNAP/compute_snad_atom.cpp b/src/ML-SNAP/compute_snad_atom.cpp index c9a88da535..623eb16268 100644 --- a/src/ML-SNAP/compute_snad_atom.cpp +++ b/src/ML-SNAP/compute_snad_atom.cpp @@ -30,8 +30,6 @@ using namespace LAMMPS_NS; -#define SNAPCOMPUTENAME "snad/atom" - ComputeSNADAtom::ComputeSNADAtom(LAMMPS *lmp, int narg, char **arg) : Compute(lmp, narg, arg), cutsq(nullptr), list(nullptr), snad(nullptr), radelem(nullptr), wjelem(nullptr), sinnerelem(nullptr), dinnerelem(nullptr) @@ -44,7 +42,7 @@ ComputeSNADAtom::ComputeSNADAtom(LAMMPS *lmp, int narg, char **arg) : int ntypes = atom->ntypes; int nargmin = 6 + 2 * ntypes; - if (narg < nargmin) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (narg < nargmin) error->all(FLERR, "Illegal compute {} command", style); // default values @@ -100,47 +98,47 @@ ComputeSNADAtom::ComputeSNADAtom(LAMMPS *lmp, int narg, char **arg) : while (iarg < narg) { if (strcmp(arg[iarg], "rmin0") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); rmin0 = utils::numeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "switchflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); switchflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "bzeroflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); bzeroflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "quadraticflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); quadraticflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "chem") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); chemflag = 1; memory->create(map, ntypes + 1, "compute_sna_grid:map"); nelements = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); for (int i = 0; i < ntypes; i++) { int jelem = utils::inumeric(FLERR, arg[iarg + 2 + i], false, lmp); - if (jelem < 0 || jelem >= nelements) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (jelem < 0 || jelem >= nelements) error->all(FLERR, "Illegal compute {} command", style); map[i + 1] = jelem; } iarg += 2 + ntypes; } else if (strcmp(arg[iarg], "bnormflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); bnormflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "wselfallflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); wselfallflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "switchinnerflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); switchinnerflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "sinner") == 0) { iarg++; - if (iarg + ntypes > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + ntypes > narg) error->all(FLERR, "Illegal compute {} command", style); memory->create(sinnerelem, ntypes + 1, "snap:sinnerelem"); for (int i = 0; i < ntypes; i++) sinnerelem[i + 1] = utils::numeric(FLERR, arg[iarg + i], false, lmp); @@ -148,25 +146,25 @@ ComputeSNADAtom::ComputeSNADAtom(LAMMPS *lmp, int narg, char **arg) : iarg += ntypes; } else if (strcmp(arg[iarg], "dinner") == 0) { iarg++; - if (iarg + ntypes > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + ntypes > narg) error->all(FLERR, "Illegal compute {} command", style); memory->create(dinnerelem, ntypes + 1, "snap:dinnerelem"); for (int i = 0; i < ntypes; i++) dinnerelem[i + 1] = utils::numeric(FLERR, arg[iarg + i], false, lmp); dinnerflag = 1; iarg += ntypes; } else - error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + error->all(FLERR, "Illegal compute {} command", style); } if (switchinnerflag && !(sinnerflag && dinnerflag)) error->all( FLERR, - "Illegal compute ", SNAPCOMPUTENAME, " command: switchinnerflag = 1, missing sinner/dinner keyword"); + "Illegal compute {} command:, style switchinnerflag = 1, missing sinner/dinner keyword"); if (!switchinnerflag && (sinnerflag || dinnerflag)) error->all( FLERR, - "Illegal compute ", SNAPCOMPUTENAME, " command: switchinnerflag = 0, unexpected sinner/dinner keyword"); + "Illegal compute {} command:, style switchinnerflag = 0, unexpected sinner/dinner keyword"); snaptr = new SNA(lmp, rfac0, twojmax, rmin0, switchflag, bzeroflag, chemflag, bnormflag, wselfallflag, nelements, switchinnerflag); diff --git a/src/ML-SNAP/compute_snap.cpp b/src/ML-SNAP/compute_snap.cpp index 64daaa4c1e..2aa503021c 100644 --- a/src/ML-SNAP/compute_snap.cpp +++ b/src/ML-SNAP/compute_snap.cpp @@ -32,8 +32,6 @@ using namespace LAMMPS_NS; enum{SCALAR,VECTOR,ARRAY}; -#define SNAPCOMPUTENAME "snap" - ComputeSnap::ComputeSnap(LAMMPS *lmp, int narg, char **arg) : Compute(lmp, narg, arg), cutsq(nullptr), list(nullptr), snap(nullptr), snapall(nullptr), snap_peratom(nullptr), radelem(nullptr), wjelem(nullptr), @@ -51,7 +49,7 @@ ComputeSnap::ComputeSnap(LAMMPS *lmp, int narg, char **arg) : int ntypes = atom->ntypes; int nargmin = 6 + 2 * ntypes; - if (narg < nargmin) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (narg < nargmin) error->all(FLERR, "Illegal compute {} command", style); // default values @@ -107,47 +105,47 @@ ComputeSnap::ComputeSnap(LAMMPS *lmp, int narg, char **arg) : while (iarg < narg) { if (strcmp(arg[iarg], "rmin0") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); rmin0 = utils::numeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "switchflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); switchflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "bzeroflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); bzeroflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "quadraticflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); quadraticflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "chem") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); chemflag = 1; memory->create(map, ntypes + 1, "compute_sna_grid:map"); nelements = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); for (int i = 0; i < ntypes; i++) { int jelem = utils::inumeric(FLERR, arg[iarg + 2 + i], false, lmp); - if (jelem < 0 || jelem >= nelements) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (jelem < 0 || jelem >= nelements) error->all(FLERR, "Illegal compute {} command", style); map[i + 1] = jelem; } iarg += 2 + ntypes; } else if (strcmp(arg[iarg], "bnormflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); bnormflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "wselfallflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); wselfallflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "switchinnerflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); switchinnerflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "sinner") == 0) { iarg++; - if (iarg + ntypes > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + ntypes > narg) error->all(FLERR, "Illegal compute {} command", style); memory->create(sinnerelem, ntypes + 1, "snap:sinnerelem"); for (int i = 0; i < ntypes; i++) sinnerelem[i + 1] = utils::numeric(FLERR, arg[iarg + i], false, lmp); @@ -155,25 +153,25 @@ ComputeSnap::ComputeSnap(LAMMPS *lmp, int narg, char **arg) : iarg += ntypes; } else if (strcmp(arg[iarg], "dinner") == 0) { iarg++; - if (iarg + ntypes > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + ntypes > narg) error->all(FLERR, "Illegal compute {} command", style); memory->create(dinnerelem, ntypes + 1, "snap:dinnerelem"); for (int i = 0; i < ntypes; i++) dinnerelem[i + 1] = utils::numeric(FLERR, arg[iarg + i], false, lmp); dinnerflag = 1; iarg += ntypes; } else - error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + error->all(FLERR, "Illegal compute {} command", style); } if (switchinnerflag && !(sinnerflag && dinnerflag)) error->all( FLERR, - "Illegal compute ", SNAPCOMPUTENAME, " command: switchinnerflag = 1, missing sinner/dinner keyword"); + "Illegal compute {} command:, style switchinnerflag = 1, missing sinner/dinner keyword"); if (!switchinnerflag && (sinnerflag || dinnerflag)) error->all( FLERR, - "Illegal compute ", SNAPCOMPUTENAME, " command: switchinnerflag = 0, unexpected sinner/dinner keyword"); + "Illegal compute {} command:, style switchinnerflag = 0, unexpected sinner/dinner keyword"); snaptr = new SNA(lmp, rfac0, twojmax, rmin0, switchflag, bzeroflag, chemflag, bnormflag, wselfallflag, nelements, switchinnerflag); diff --git a/src/ML-SNAP/compute_snav_atom.cpp b/src/ML-SNAP/compute_snav_atom.cpp index b2fa24b231..74d52e231a 100644 --- a/src/ML-SNAP/compute_snav_atom.cpp +++ b/src/ML-SNAP/compute_snav_atom.cpp @@ -30,8 +30,6 @@ using namespace LAMMPS_NS; -#define SNAPCOMPUTENAME "snav/atom" - ComputeSNAVAtom::ComputeSNAVAtom(LAMMPS *lmp, int narg, char **arg) : Compute(lmp, narg, arg), cutsq(nullptr), list(nullptr), snav(nullptr), radelem(nullptr), wjelem(nullptr), sinnerelem(nullptr), dinnerelem(nullptr) @@ -44,7 +42,7 @@ ComputeSNAVAtom::ComputeSNAVAtom(LAMMPS *lmp, int narg, char **arg) : int ntypes = atom->ntypes; int nargmin = 6 + 2 * ntypes; - if (narg < nargmin) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (narg < nargmin) error->all(FLERR, "Illegal compute {} command", style); // default values @@ -100,47 +98,47 @@ ComputeSNAVAtom::ComputeSNAVAtom(LAMMPS *lmp, int narg, char **arg) : while (iarg < narg) { if (strcmp(arg[iarg], "rmin0") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); rmin0 = utils::numeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "switchflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); switchflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "bzeroflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); bzeroflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "quadraticflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); quadraticflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "chem") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); chemflag = 1; memory->create(map, ntypes + 1, "compute_sna_grid:map"); nelements = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); for (int i = 0; i < ntypes; i++) { int jelem = utils::inumeric(FLERR, arg[iarg + 2 + i], false, lmp); - if (jelem < 0 || jelem >= nelements) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (jelem < 0 || jelem >= nelements) error->all(FLERR, "Illegal compute {} command", style); map[i + 1] = jelem; } iarg += 2 + ntypes; } else if (strcmp(arg[iarg], "bnormflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); bnormflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "wselfallflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); wselfallflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "switchinnerflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); switchinnerflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "sinner") == 0) { iarg++; - if (iarg + ntypes > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + ntypes > narg) error->all(FLERR, "Illegal compute {} command", style); memory->create(sinnerelem, ntypes + 1, "snap:sinnerelem"); for (int i = 0; i < ntypes; i++) sinnerelem[i + 1] = utils::numeric(FLERR, arg[iarg + i], false, lmp); @@ -148,25 +146,25 @@ ComputeSNAVAtom::ComputeSNAVAtom(LAMMPS *lmp, int narg, char **arg) : iarg += ntypes; } else if (strcmp(arg[iarg], "dinner") == 0) { iarg++; - if (iarg + ntypes > narg) error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + if (iarg + ntypes > narg) error->all(FLERR, "Illegal compute {} command", style); memory->create(dinnerelem, ntypes + 1, "snap:dinnerelem"); for (int i = 0; i < ntypes; i++) dinnerelem[i + 1] = utils::numeric(FLERR, arg[iarg + i], false, lmp); dinnerflag = 1; iarg += ntypes; } else - error->all(FLERR, "Illegal compute ", SNAPCOMPUTENAME, " command"); + error->all(FLERR, "Illegal compute {} command", style); } if (switchinnerflag && !(sinnerflag && dinnerflag)) error->all( FLERR, - "Illegal compute ", SNAPCOMPUTENAME, " command: switchinnerflag = 1, missing sinner/dinner keyword"); + "Illegal compute {} command:, style switchinnerflag = 1, missing sinner/dinner keyword"); if (!switchinnerflag && (sinnerflag || dinnerflag)) error->all( FLERR, - "Illegal compute ", SNAPCOMPUTENAME, " command: switchinnerflag = 0, unexpected sinner/dinner keyword"); + "Illegal compute {} command:, style switchinnerflag = 0, unexpected sinner/dinner keyword"); snaptr = new SNA(lmp, rfac0, twojmax, rmin0, switchflag, bzeroflag, chemflag, bnormflag, wselfallflag, nelements, switchinnerflag); From b3fea1cb71d1f3e47dceacf07e0d252bd9670fdd Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 17 Jun 2022 19:48:09 -0400 Subject: [PATCH 402/585] make spellchecker happy --- doc/src/compute_sna_atom.rst | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/doc/src/compute_sna_atom.rst b/doc/src/compute_sna_atom.rst index 242defe614..f6946b421d 100644 --- a/doc/src/compute_sna_atom.rst +++ b/doc/src/compute_sna_atom.rst @@ -252,7 +252,7 @@ layout in the global array. Compute *sna/grid/local* calculates bispectrum components of a regular grid of points similarly to compute *sna/grid* described above. However, because the array is local, it contains only rows for grid points -that are local to the processor subdomain. The global grid +that are local to the processor sub-domain. The global grid of :math:`nx \times ny \times nz` points is still laid out in space the same as for *sna/grid*, but grid points are strictly partitioned, so that every grid point appears in one and only one local array. The array contains one row for each of the From eb69bb28b8c266d4c41848b8dfb0945130f81e1d Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 17 Jun 2022 21:52:57 -0400 Subject: [PATCH 403/585] add missing style index entries --- doc/src/compute_sna_atom.rst | 2 ++ 1 file changed, 2 insertions(+) diff --git a/doc/src/compute_sna_atom.rst b/doc/src/compute_sna_atom.rst index f6946b421d..354a9a8fa6 100644 --- a/doc/src/compute_sna_atom.rst +++ b/doc/src/compute_sna_atom.rst @@ -2,6 +2,8 @@ .. index:: compute snad/atom .. index:: compute snav/atom .. index:: compute snap +.. index:: compute sna/grid +.. index:: compute sna/grid/local compute sna/atom command ======================== From f831a776beb5318c4249ad77b2ac5f71d75e7b54 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sat, 18 Jun 2022 22:25:32 -0400 Subject: [PATCH 404/585] correct python example --- doc/src/Howto_structured_data.rst | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/doc/src/Howto_structured_data.rst b/doc/src/Howto_structured_data.rst index 4ea6c28086..18a5dfd775 100644 --- a/doc/src/Howto_structured_data.rst +++ b/doc/src/Howto_structured_data.rst @@ -184,7 +184,7 @@ frame. .. code-block:: python - import re, yaml + import yaml import pandas as pd try: @@ -193,7 +193,7 @@ frame. from yaml import SafeLoader as Loader with open("ave.yaml") as f: - ave = yaml.load(docs, Loader=Loader) + ave = yaml.load(f, Loader=Loader) keys = ave['keywords'] df = {} From 063fc47f6478c272d01cdb002e5152d66ec0a828 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sun, 19 Jun 2022 06:38:14 -0400 Subject: [PATCH 405/585] tweak to avoid test failure on FreeBSD --- unittest/force-styles/tests/manybody-pair-pace_product.yaml | 2 +- unittest/force-styles/tests/manybody-pair-pace_recursive.yaml | 2 +- 2 files changed, 2 insertions(+), 2 deletions(-) diff --git a/unittest/force-styles/tests/manybody-pair-pace_product.yaml b/unittest/force-styles/tests/manybody-pair-pace_product.yaml index 1e82029777..b178586ab2 100644 --- a/unittest/force-styles/tests/manybody-pair-pace_product.yaml +++ b/unittest/force-styles/tests/manybody-pair-pace_product.yaml @@ -1,7 +1,7 @@ --- lammps_version: 17 Feb 2022 date_generated: Fri Mar 18 22:17:48 2022 -epsilon: 1e-12 +epsilon: 5e-12 skip_tests: prerequisites: ! | pair pace diff --git a/unittest/force-styles/tests/manybody-pair-pace_recursive.yaml b/unittest/force-styles/tests/manybody-pair-pace_recursive.yaml index f20440c85d..6105debb67 100644 --- a/unittest/force-styles/tests/manybody-pair-pace_recursive.yaml +++ b/unittest/force-styles/tests/manybody-pair-pace_recursive.yaml @@ -1,7 +1,7 @@ --- lammps_version: 10 Mar 2021 date_generated: Wed Apr 7 19:30:07 2021 -epsilon: 1e-12 +epsilon: 5e-12 prerequisites: ! | pair pace pre_commands: ! | From de4558aa07fef7301dd6352761b03fc89fb501f4 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Sun, 19 Jun 2022 09:58:01 -0600 Subject: [PATCH 406/585] Tweaked error messages --- src/ML-SNAP/compute_sna_atom.cpp | 9 +++++--- src/ML-SNAP/compute_sna_grid.cpp | 30 +++++++++++++++---------- src/ML-SNAP/compute_sna_grid_local.cpp | 31 +++++++++++++++----------- src/ML-SNAP/compute_snad_atom.cpp | 18 +++++++++------ src/ML-SNAP/compute_snap.cpp | 15 ++++++++----- src/ML-SNAP/compute_snav_atom.cpp | 20 ++++++++++------- 6 files changed, 74 insertions(+), 49 deletions(-) diff --git a/src/ML-SNAP/compute_sna_atom.cpp b/src/ML-SNAP/compute_sna_atom.cpp index daec59e3f0..9dce3d6e6d 100644 --- a/src/ML-SNAP/compute_sna_atom.cpp +++ b/src/ML-SNAP/compute_sna_atom.cpp @@ -35,7 +35,7 @@ ComputeSNAAtom::ComputeSNAAtom(LAMMPS *lmp, int narg, char **arg) : radelem(nullptr), wjelem(nullptr), sinnerelem(nullptr), dinnerelem(nullptr) { - // code common to all SNAP computes + // begin code common to all SNAP computes double rfac0, rmin0; int twojmax, switchflag, bzeroflag, bnormflag, wselfallflag; @@ -160,12 +160,15 @@ ComputeSNAAtom::ComputeSNAAtom(LAMMPS *lmp, int narg, char **arg) : if (switchinnerflag && !(sinnerflag && dinnerflag)) error->all( FLERR, - "Illegal compute {} command:, style switchinnerflag = 1, missing sinner/dinner keyword"); + "Illegal compute {} command:, style switchinnerflag = 1, missing sinner/dinner keyword", + style); if (!switchinnerflag && (sinnerflag || dinnerflag)) error->all( FLERR, - "Illegal compute {} command:, style switchinnerflag = 0, unexpected sinner/dinner keyword"); + "Illegal compute {} command:, style switchinnerflag = 0, unexpected sinner/dinner keyword", + style); + snaptr = new SNA(lmp, rfac0, twojmax, rmin0, switchflag, bzeroflag, chemflag, bnormflag, wselfallflag, nelements, switchinnerflag); diff --git a/src/ML-SNAP/compute_sna_grid.cpp b/src/ML-SNAP/compute_sna_grid.cpp index f8da915051..dc92ee2b15 100644 --- a/src/ML-SNAP/compute_sna_grid.cpp +++ b/src/ML-SNAP/compute_sna_grid.cpp @@ -37,7 +37,7 @@ ComputeSNAGrid::ComputeSNAGrid(LAMMPS *lmp, int narg, char **arg) : arg += nargbase; narg -= nargbase; - // code common to all SNAP computes + // begin code common to all SNAP computes double rfac0, rmin0; int twojmax, switchflag, bzeroflag, bnormflag, wselfallflag; @@ -61,22 +61,25 @@ ComputeSNAGrid::ComputeSNAGrid(LAMMPS *lmp, int narg, char **arg) : // process required arguments - memory->create(radelem, ntypes + 1, "sna/grid:radelem"); // offset by 1 to match up with types - memory->create(wjelem, ntypes + 1, "sna/grid:wjelem"); + memory->create(radelem, ntypes + 1, "sna/atom:radelem"); // offset by 1 to match up with types + memory->create(wjelem, ntypes + 1, "sna/atom:wjelem"); rcutfac = utils::numeric(FLERR, arg[3], false, lmp); rfac0 = utils::numeric(FLERR, arg[4], false, lmp); twojmax = utils::inumeric(FLERR, arg[5], false, lmp); - for (int i = 0; i < ntypes; i++) radelem[i + 1] = utils::numeric(FLERR, arg[6 + i], false, lmp); for (int i = 0; i < ntypes; i++) - wjelem[i + 1] = utils::numeric(FLERR, arg[6 + ntypes + i], false, lmp); + radelem[i + 1] = + utils::numeric(FLERR, arg[6 + i], false, lmp); + for (int i = 0; i < ntypes; i++) + wjelem[i + 1] = + utils::numeric(FLERR, arg[6 + ntypes + i], false, lmp); // construct cutsq double cut; cutmax = 0.0; - memory->create(cutsq, ntypes + 1, ntypes + 1, "sna/grid:cutsq"); + memory->create(cutsq, ntypes + 1, ntypes + 1, "sna/atom:cutsq"); for (int i = 1; i <= ntypes; i++) { cut = 2.0 * radelem[i] * rcutfac; if (cut > cutmax) cutmax = cut; @@ -157,14 +160,17 @@ ComputeSNAGrid::ComputeSNAGrid(LAMMPS *lmp, int narg, char **arg) : } if (switchinnerflag && !(sinnerflag && dinnerflag)) - error->all(FLERR, - "Illegal compute {} command: switchinnerflag = 1, missing sinner/dinner keyword", - style); + error->all( + FLERR, + "Illegal compute {} command:, style switchinnerflag = 1, missing sinner/dinner keyword", + style); if (!switchinnerflag && (sinnerflag || dinnerflag)) - error->all(FLERR, - "Illegal compute {} command: switchinnerflag = 0, unexpected sinner/dinner keyword", - style); + error->all( + FLERR, + "Illegal compute {} command:, style switchinnerflag = 0, unexpected sinner/dinner keyword", + style); + snaptr = new SNA(lmp, rfac0, twojmax, rmin0, switchflag, bzeroflag, chemflag, bnormflag, wselfallflag, nelements, switchinnerflag); diff --git a/src/ML-SNAP/compute_sna_grid_local.cpp b/src/ML-SNAP/compute_sna_grid_local.cpp index 079ecac319..8b0121b9ce 100644 --- a/src/ML-SNAP/compute_sna_grid_local.cpp +++ b/src/ML-SNAP/compute_sna_grid_local.cpp @@ -37,7 +37,7 @@ ComputeSNAGridLocal::ComputeSNAGridLocal(LAMMPS *lmp, int narg, char **arg) : arg += nargbase; narg -= nargbase; - // code common to all SNAP computes + // begin code common to all SNAP computes double rfac0, rmin0; int twojmax, switchflag, bzeroflag, bnormflag, wselfallflag; @@ -61,23 +61,25 @@ ComputeSNAGridLocal::ComputeSNAGridLocal(LAMMPS *lmp, int narg, char **arg) : // process required arguments - memory->create(radelem, ntypes + 1, - "sna/grid/local:radelem"); // offset by 1 to match up with types - memory->create(wjelem, ntypes + 1, "sna/grid/local:wjelem"); + memory->create(radelem, ntypes + 1, "sna/atom:radelem"); // offset by 1 to match up with types + memory->create(wjelem, ntypes + 1, "sna/atom:wjelem"); rcutfac = utils::numeric(FLERR, arg[3], false, lmp); rfac0 = utils::numeric(FLERR, arg[4], false, lmp); twojmax = utils::inumeric(FLERR, arg[5], false, lmp); - for (int i = 0; i < ntypes; i++) radelem[i + 1] = utils::numeric(FLERR, arg[6 + i], false, lmp); for (int i = 0; i < ntypes; i++) - wjelem[i + 1] = utils::numeric(FLERR, arg[6 + ntypes + i], false, lmp); + radelem[i + 1] = + utils::numeric(FLERR, arg[6 + i], false, lmp); + for (int i = 0; i < ntypes; i++) + wjelem[i + 1] = + utils::numeric(FLERR, arg[6 + ntypes + i], false, lmp); // construct cutsq double cut; cutmax = 0.0; - memory->create(cutsq, ntypes + 1, ntypes + 1, "sna/grid/local:cutsq"); + memory->create(cutsq, ntypes + 1, ntypes + 1, "sna/atom:cutsq"); for (int i = 1; i <= ntypes; i++) { cut = 2.0 * radelem[i] * rcutfac; if (cut > cutmax) cutmax = cut; @@ -158,14 +160,17 @@ ComputeSNAGridLocal::ComputeSNAGridLocal(LAMMPS *lmp, int narg, char **arg) : } if (switchinnerflag && !(sinnerflag && dinnerflag)) - error->all(FLERR, - "Illegal compute {} command: switchinnerflag = 1, missing sinner/dinner keyword", - style); + error->all( + FLERR, + "Illegal compute {} command:, style switchinnerflag = 1, missing sinner/dinner keyword", + style); if (!switchinnerflag && (sinnerflag || dinnerflag)) - error->all(FLERR, - "Illegal compute {} command: switchinnerflag = 0, unexpected sinner/dinner keyword", - style); + error->all( + FLERR, + "Illegal compute {} command:, style switchinnerflag = 0, unexpected sinner/dinner keyword", + style); + snaptr = new SNA(lmp, rfac0, twojmax, rmin0, switchflag, bzeroflag, chemflag, bnormflag, wselfallflag, nelements, switchinnerflag); diff --git a/src/ML-SNAP/compute_snad_atom.cpp b/src/ML-SNAP/compute_snad_atom.cpp index 623eb16268..1cd2278b00 100644 --- a/src/ML-SNAP/compute_snad_atom.cpp +++ b/src/ML-SNAP/compute_snad_atom.cpp @@ -34,7 +34,8 @@ ComputeSNADAtom::ComputeSNADAtom(LAMMPS *lmp, int narg, char **arg) : Compute(lmp, narg, arg), cutsq(nullptr), list(nullptr), snad(nullptr), radelem(nullptr), wjelem(nullptr), sinnerelem(nullptr), dinnerelem(nullptr) { - // code common to all SNAP computes + + // begin code common to all SNAP computes double rfac0, rmin0; int twojmax, switchflag, bzeroflag, bnormflag, wselfallflag; @@ -58,8 +59,8 @@ ComputeSNADAtom::ComputeSNADAtom(LAMMPS *lmp, int narg, char **arg) : // process required arguments - memory->create(radelem, ntypes + 1, "snad/atom:radelem"); // offset by 1 to match up with types - memory->create(wjelem, ntypes + 1, "snad/atom:wjelem"); + memory->create(radelem, ntypes + 1, "sna/atom:radelem"); // offset by 1 to match up with types + memory->create(wjelem, ntypes + 1, "sna/atom:wjelem"); rcutfac = utils::numeric(FLERR, arg[3], false, lmp); rfac0 = utils::numeric(FLERR, arg[4], false, lmp); @@ -76,7 +77,7 @@ ComputeSNADAtom::ComputeSNADAtom(LAMMPS *lmp, int narg, char **arg) : double cut; cutmax = 0.0; - memory->create(cutsq, ntypes + 1, ntypes + 1, "snad/atom:cutsq"); + memory->create(cutsq, ntypes + 1, ntypes + 1, "sna/atom:cutsq"); for (int i = 1; i <= ntypes; i++) { cut = 2.0 * radelem[i] * rcutfac; if (cut > cutmax) cutmax = cut; @@ -159,12 +160,15 @@ ComputeSNADAtom::ComputeSNADAtom(LAMMPS *lmp, int narg, char **arg) : if (switchinnerflag && !(sinnerflag && dinnerflag)) error->all( FLERR, - "Illegal compute {} command:, style switchinnerflag = 1, missing sinner/dinner keyword"); + "Illegal compute {} command:, style switchinnerflag = 1, missing sinner/dinner keyword", + style); if (!switchinnerflag && (sinnerflag || dinnerflag)) error->all( FLERR, - "Illegal compute {} command:, style switchinnerflag = 0, unexpected sinner/dinner keyword"); + "Illegal compute {} command:, style switchinnerflag = 0, unexpected sinner/dinner keyword", + style); + snaptr = new SNA(lmp, rfac0, twojmax, rmin0, switchflag, bzeroflag, chemflag, bnormflag, wselfallflag, nelements, switchinnerflag); @@ -174,7 +178,7 @@ ComputeSNADAtom::ComputeSNADAtom(LAMMPS *lmp, int narg, char **arg) : if (quadraticflag) nvalues += (ncoeff * (ncoeff + 1)) / 2; // end code common to all SNAP computes - + yoffset = nvalues; zoffset = 2*nvalues; size_peratom_cols = 3*nvalues*atom->ntypes; diff --git a/src/ML-SNAP/compute_snap.cpp b/src/ML-SNAP/compute_snap.cpp index 2aa503021c..fb10fa0fbe 100644 --- a/src/ML-SNAP/compute_snap.cpp +++ b/src/ML-SNAP/compute_snap.cpp @@ -41,7 +41,7 @@ ComputeSnap::ComputeSnap(LAMMPS *lmp, int narg, char **arg) : array_flag = 1; extarray = 0; - // code common to all SNAP computes + // begin code common to all SNAP computes double rfac0, rmin0; int twojmax, switchflag, bzeroflag, bnormflag, wselfallflag; @@ -65,8 +65,8 @@ ComputeSnap::ComputeSnap(LAMMPS *lmp, int narg, char **arg) : // process required arguments - memory->create(radelem, ntypes + 1, "snap:radelem"); // offset by 1 to match up with types - memory->create(wjelem, ntypes + 1, "snap:wjelem"); + memory->create(radelem, ntypes + 1, "sna/atom:radelem"); // offset by 1 to match up with types + memory->create(wjelem, ntypes + 1, "sna/atom:wjelem"); rcutfac = utils::numeric(FLERR, arg[3], false, lmp); rfac0 = utils::numeric(FLERR, arg[4], false, lmp); @@ -83,7 +83,7 @@ ComputeSnap::ComputeSnap(LAMMPS *lmp, int narg, char **arg) : double cut; cutmax = 0.0; - memory->create(cutsq, ntypes + 1, ntypes + 1, "snap:cutsq"); + memory->create(cutsq, ntypes + 1, ntypes + 1, "sna/atom:cutsq"); for (int i = 1; i <= ntypes; i++) { cut = 2.0 * radelem[i] * rcutfac; if (cut > cutmax) cutmax = cut; @@ -166,12 +166,15 @@ ComputeSnap::ComputeSnap(LAMMPS *lmp, int narg, char **arg) : if (switchinnerflag && !(sinnerflag && dinnerflag)) error->all( FLERR, - "Illegal compute {} command:, style switchinnerflag = 1, missing sinner/dinner keyword"); + "Illegal compute {} command:, style switchinnerflag = 1, missing sinner/dinner keyword", + style); if (!switchinnerflag && (sinnerflag || dinnerflag)) error->all( FLERR, - "Illegal compute {} command:, style switchinnerflag = 0, unexpected sinner/dinner keyword"); + "Illegal compute {} command:, style switchinnerflag = 0, unexpected sinner/dinner keyword", + style); + snaptr = new SNA(lmp, rfac0, twojmax, rmin0, switchflag, bzeroflag, chemflag, bnormflag, wselfallflag, nelements, switchinnerflag); diff --git a/src/ML-SNAP/compute_snav_atom.cpp b/src/ML-SNAP/compute_snav_atom.cpp index 74d52e231a..4b7b0caa64 100644 --- a/src/ML-SNAP/compute_snav_atom.cpp +++ b/src/ML-SNAP/compute_snav_atom.cpp @@ -34,7 +34,8 @@ ComputeSNAVAtom::ComputeSNAVAtom(LAMMPS *lmp, int narg, char **arg) : Compute(lmp, narg, arg), cutsq(nullptr), list(nullptr), snav(nullptr), radelem(nullptr), wjelem(nullptr), sinnerelem(nullptr), dinnerelem(nullptr) { - // code common to all SNAP computes + + // begin code common to all SNAP computes double rfac0, rmin0; int twojmax, switchflag, bzeroflag, bnormflag, wselfallflag; @@ -58,8 +59,8 @@ ComputeSNAVAtom::ComputeSNAVAtom(LAMMPS *lmp, int narg, char **arg) : // process required arguments - memory->create(radelem, ntypes + 1, "snav/atom:radelem"); // offset by 1 to match up with types - memory->create(wjelem, ntypes + 1, "snav/atom:wjelem"); + memory->create(radelem, ntypes + 1, "sna/atom:radelem"); // offset by 1 to match up with types + memory->create(wjelem, ntypes + 1, "sna/atom:wjelem"); rcutfac = utils::numeric(FLERR, arg[3], false, lmp); rfac0 = utils::numeric(FLERR, arg[4], false, lmp); @@ -76,7 +77,7 @@ ComputeSNAVAtom::ComputeSNAVAtom(LAMMPS *lmp, int narg, char **arg) : double cut; cutmax = 0.0; - memory->create(cutsq, ntypes + 1, ntypes + 1, "snav/atom:cutsq"); + memory->create(cutsq, ntypes + 1, ntypes + 1, "sna/atom:cutsq"); for (int i = 1; i <= ntypes; i++) { cut = 2.0 * radelem[i] * rcutfac; if (cut > cutmax) cutmax = cut; @@ -159,12 +160,15 @@ ComputeSNAVAtom::ComputeSNAVAtom(LAMMPS *lmp, int narg, char **arg) : if (switchinnerflag && !(sinnerflag && dinnerflag)) error->all( FLERR, - "Illegal compute {} command:, style switchinnerflag = 1, missing sinner/dinner keyword"); + "Illegal compute {} command:, style switchinnerflag = 1, missing sinner/dinner keyword", + style); if (!switchinnerflag && (sinnerflag || dinnerflag)) error->all( FLERR, - "Illegal compute {} command:, style switchinnerflag = 0, unexpected sinner/dinner keyword"); + "Illegal compute {} command:, style switchinnerflag = 0, unexpected sinner/dinner keyword", + style); + snaptr = new SNA(lmp, rfac0, twojmax, rmin0, switchflag, bzeroflag, chemflag, bnormflag, wselfallflag, nelements, switchinnerflag); @@ -174,8 +178,8 @@ ComputeSNAVAtom::ComputeSNAVAtom(LAMMPS *lmp, int narg, char **arg) : if (quadraticflag) nvalues += (ncoeff * (ncoeff + 1)) / 2; // end code common to all SNAP computes - - size_peratom_cols = 6*nvalues*atom->ntypes; + + size_peratom_cols = 6*nvalues*atom->ntypes; comm_reverse = size_peratom_cols; peratom_flag = 1; From f632cff8f245d18d0696b17f02342a0e1c609681 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sun, 19 Jun 2022 16:11:37 -0400 Subject: [PATCH 407/585] remove excess text and re-apply clang-format --- src/ML-SNAP/compute_sna_atom.cpp | 9 ++++----- src/ML-SNAP/compute_sna_grid.cpp | 24 +++++++++--------------- src/ML-SNAP/compute_sna_grid_local.cpp | 24 +++++++++--------------- src/ML-SNAP/compute_snad_atom.cpp | 9 ++++----- src/ML-SNAP/compute_snap.cpp | 9 ++++----- src/ML-SNAP/compute_snav_atom.cpp | 9 ++++----- 6 files changed, 34 insertions(+), 50 deletions(-) diff --git a/src/ML-SNAP/compute_sna_atom.cpp b/src/ML-SNAP/compute_sna_atom.cpp index 9dce3d6e6d..1d2190d50d 100644 --- a/src/ML-SNAP/compute_sna_atom.cpp +++ b/src/ML-SNAP/compute_sna_atom.cpp @@ -160,15 +160,14 @@ ComputeSNAAtom::ComputeSNAAtom(LAMMPS *lmp, int narg, char **arg) : if (switchinnerflag && !(sinnerflag && dinnerflag)) error->all( FLERR, - "Illegal compute {} command:, style switchinnerflag = 1, missing sinner/dinner keyword", - style); + "Illegal compute {} command: switchinnerflag = 1, missing sinner/dinner keyword", + style); if (!switchinnerflag && (sinnerflag || dinnerflag)) error->all( FLERR, - "Illegal compute {} command:, style switchinnerflag = 0, unexpected sinner/dinner keyword", - style); - + "Illegal compute {} command: switchinnerflag = 0, unexpected sinner/dinner keyword", + style); snaptr = new SNA(lmp, rfac0, twojmax, rmin0, switchflag, bzeroflag, chemflag, bnormflag, wselfallflag, nelements, switchinnerflag); diff --git a/src/ML-SNAP/compute_sna_grid.cpp b/src/ML-SNAP/compute_sna_grid.cpp index dc92ee2b15..ac267112b1 100644 --- a/src/ML-SNAP/compute_sna_grid.cpp +++ b/src/ML-SNAP/compute_sna_grid.cpp @@ -61,19 +61,16 @@ ComputeSNAGrid::ComputeSNAGrid(LAMMPS *lmp, int narg, char **arg) : // process required arguments - memory->create(radelem, ntypes + 1, "sna/atom:radelem"); // offset by 1 to match up with types + memory->create(radelem, ntypes + 1, "sna/atom:radelem"); // offset by 1 to match up with types memory->create(wjelem, ntypes + 1, "sna/atom:wjelem"); rcutfac = utils::numeric(FLERR, arg[3], false, lmp); rfac0 = utils::numeric(FLERR, arg[4], false, lmp); twojmax = utils::inumeric(FLERR, arg[5], false, lmp); + for (int i = 0; i < ntypes; i++) radelem[i + 1] = utils::numeric(FLERR, arg[6 + i], false, lmp); for (int i = 0; i < ntypes; i++) - radelem[i + 1] = - utils::numeric(FLERR, arg[6 + i], false, lmp); - for (int i = 0; i < ntypes; i++) - wjelem[i + 1] = - utils::numeric(FLERR, arg[6 + ntypes + i], false, lmp); + wjelem[i + 1] = utils::numeric(FLERR, arg[6 + ntypes + i], false, lmp); // construct cutsq @@ -160,17 +157,14 @@ ComputeSNAGrid::ComputeSNAGrid(LAMMPS *lmp, int narg, char **arg) : } if (switchinnerflag && !(sinnerflag && dinnerflag)) - error->all( - FLERR, - "Illegal compute {} command:, style switchinnerflag = 1, missing sinner/dinner keyword", - style); + error->all(FLERR, + "Illegal compute {} command: switchinnerflag = 1, missing sinner/dinner keyword", + style); if (!switchinnerflag && (sinnerflag || dinnerflag)) - error->all( - FLERR, - "Illegal compute {} command:, style switchinnerflag = 0, unexpected sinner/dinner keyword", - style); - + error->all(FLERR, + "Illegal compute {} command: switchinnerflag = 0, unexpected sinner/dinner keyword", + style); snaptr = new SNA(lmp, rfac0, twojmax, rmin0, switchflag, bzeroflag, chemflag, bnormflag, wselfallflag, nelements, switchinnerflag); diff --git a/src/ML-SNAP/compute_sna_grid_local.cpp b/src/ML-SNAP/compute_sna_grid_local.cpp index 8b0121b9ce..059f177696 100644 --- a/src/ML-SNAP/compute_sna_grid_local.cpp +++ b/src/ML-SNAP/compute_sna_grid_local.cpp @@ -61,19 +61,16 @@ ComputeSNAGridLocal::ComputeSNAGridLocal(LAMMPS *lmp, int narg, char **arg) : // process required arguments - memory->create(radelem, ntypes + 1, "sna/atom:radelem"); // offset by 1 to match up with types + memory->create(radelem, ntypes + 1, "sna/atom:radelem"); // offset by 1 to match up with types memory->create(wjelem, ntypes + 1, "sna/atom:wjelem"); rcutfac = utils::numeric(FLERR, arg[3], false, lmp); rfac0 = utils::numeric(FLERR, arg[4], false, lmp); twojmax = utils::inumeric(FLERR, arg[5], false, lmp); + for (int i = 0; i < ntypes; i++) radelem[i + 1] = utils::numeric(FLERR, arg[6 + i], false, lmp); for (int i = 0; i < ntypes; i++) - radelem[i + 1] = - utils::numeric(FLERR, arg[6 + i], false, lmp); - for (int i = 0; i < ntypes; i++) - wjelem[i + 1] = - utils::numeric(FLERR, arg[6 + ntypes + i], false, lmp); + wjelem[i + 1] = utils::numeric(FLERR, arg[6 + ntypes + i], false, lmp); // construct cutsq @@ -160,17 +157,14 @@ ComputeSNAGridLocal::ComputeSNAGridLocal(LAMMPS *lmp, int narg, char **arg) : } if (switchinnerflag && !(sinnerflag && dinnerflag)) - error->all( - FLERR, - "Illegal compute {} command:, style switchinnerflag = 1, missing sinner/dinner keyword", - style); + error->all(FLERR, + "Illegal compute {} command: switchinnerflag = 1, missing sinner/dinner keyword", + style); if (!switchinnerflag && (sinnerflag || dinnerflag)) - error->all( - FLERR, - "Illegal compute {} command:, style switchinnerflag = 0, unexpected sinner/dinner keyword", - style); - + error->all(FLERR, + "Illegal compute {} command: switchinnerflag = 0, unexpected sinner/dinner keyword", + style); snaptr = new SNA(lmp, rfac0, twojmax, rmin0, switchflag, bzeroflag, chemflag, bnormflag, wselfallflag, nelements, switchinnerflag); diff --git a/src/ML-SNAP/compute_snad_atom.cpp b/src/ML-SNAP/compute_snad_atom.cpp index 1cd2278b00..9d080508f5 100644 --- a/src/ML-SNAP/compute_snad_atom.cpp +++ b/src/ML-SNAP/compute_snad_atom.cpp @@ -160,15 +160,14 @@ ComputeSNADAtom::ComputeSNADAtom(LAMMPS *lmp, int narg, char **arg) : if (switchinnerflag && !(sinnerflag && dinnerflag)) error->all( FLERR, - "Illegal compute {} command:, style switchinnerflag = 1, missing sinner/dinner keyword", - style); + "Illegal compute {} command: switchinnerflag = 1, missing sinner/dinner keyword", + style); if (!switchinnerflag && (sinnerflag || dinnerflag)) error->all( FLERR, - "Illegal compute {} command:, style switchinnerflag = 0, unexpected sinner/dinner keyword", - style); - + "Illegal compute {} command: switchinnerflag = 0, unexpected sinner/dinner keyword", + style); snaptr = new SNA(lmp, rfac0, twojmax, rmin0, switchflag, bzeroflag, chemflag, bnormflag, wselfallflag, nelements, switchinnerflag); diff --git a/src/ML-SNAP/compute_snap.cpp b/src/ML-SNAP/compute_snap.cpp index fb10fa0fbe..d1f75f8382 100644 --- a/src/ML-SNAP/compute_snap.cpp +++ b/src/ML-SNAP/compute_snap.cpp @@ -166,15 +166,14 @@ ComputeSnap::ComputeSnap(LAMMPS *lmp, int narg, char **arg) : if (switchinnerflag && !(sinnerflag && dinnerflag)) error->all( FLERR, - "Illegal compute {} command:, style switchinnerflag = 1, missing sinner/dinner keyword", - style); + "Illegal compute {} command: switchinnerflag = 1, missing sinner/dinner keyword", + style); if (!switchinnerflag && (sinnerflag || dinnerflag)) error->all( FLERR, - "Illegal compute {} command:, style switchinnerflag = 0, unexpected sinner/dinner keyword", - style); - + "Illegal compute {} command: switchinnerflag = 0, unexpected sinner/dinner keyword", + style); snaptr = new SNA(lmp, rfac0, twojmax, rmin0, switchflag, bzeroflag, chemflag, bnormflag, wselfallflag, nelements, switchinnerflag); diff --git a/src/ML-SNAP/compute_snav_atom.cpp b/src/ML-SNAP/compute_snav_atom.cpp index 4b7b0caa64..27c304b424 100644 --- a/src/ML-SNAP/compute_snav_atom.cpp +++ b/src/ML-SNAP/compute_snav_atom.cpp @@ -160,15 +160,14 @@ ComputeSNAVAtom::ComputeSNAVAtom(LAMMPS *lmp, int narg, char **arg) : if (switchinnerflag && !(sinnerflag && dinnerflag)) error->all( FLERR, - "Illegal compute {} command:, style switchinnerflag = 1, missing sinner/dinner keyword", - style); + "Illegal compute {} command: switchinnerflag = 1, missing sinner/dinner keyword", + style); if (!switchinnerflag && (sinnerflag || dinnerflag)) error->all( FLERR, - "Illegal compute {} command:, style switchinnerflag = 0, unexpected sinner/dinner keyword", - style); - + "Illegal compute {} command: switchinnerflag = 0, unexpected sinner/dinner keyword", + style); snaptr = new SNA(lmp, rfac0, twojmax, rmin0, switchflag, bzeroflag, chemflag, bnormflag, wselfallflag, nelements, switchinnerflag); From 4881b232d30a0a53d8a63ca43d75ec6f336225ba Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sun, 19 Jun 2022 16:28:55 -0400 Subject: [PATCH 408/585] whitespace --- src/ML-SNAP/compute_snad_atom.cpp | 2 +- src/ML-SNAP/compute_snav_atom.cpp | 2 +- 2 files changed, 2 insertions(+), 2 deletions(-) diff --git a/src/ML-SNAP/compute_snad_atom.cpp b/src/ML-SNAP/compute_snad_atom.cpp index 9d080508f5..12839629a9 100644 --- a/src/ML-SNAP/compute_snad_atom.cpp +++ b/src/ML-SNAP/compute_snad_atom.cpp @@ -177,7 +177,7 @@ ComputeSNADAtom::ComputeSNADAtom(LAMMPS *lmp, int narg, char **arg) : if (quadraticflag) nvalues += (ncoeff * (ncoeff + 1)) / 2; // end code common to all SNAP computes - + yoffset = nvalues; zoffset = 2*nvalues; size_peratom_cols = 3*nvalues*atom->ntypes; diff --git a/src/ML-SNAP/compute_snav_atom.cpp b/src/ML-SNAP/compute_snav_atom.cpp index 27c304b424..949dda8e5c 100644 --- a/src/ML-SNAP/compute_snav_atom.cpp +++ b/src/ML-SNAP/compute_snav_atom.cpp @@ -177,7 +177,7 @@ ComputeSNAVAtom::ComputeSNAVAtom(LAMMPS *lmp, int narg, char **arg) : if (quadraticflag) nvalues += (ncoeff * (ncoeff + 1)) / 2; // end code common to all SNAP computes - + size_peratom_cols = 6*nvalues*atom->ntypes; comm_reverse = size_peratom_cols; peratom_flag = 1; From 3828c857f7bfaa9e688604618e0c8055907ac0c0 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 20 Jun 2022 18:10:19 -0400 Subject: [PATCH 409/585] accept LMP_SIZE_VECTOR as alias for LMP_SIZE_ROWS with local computes --- src/library.cpp | 1 + 1 file changed, 1 insertion(+) diff --git a/src/library.cpp b/src/library.cpp index 079534d663..de655d74d0 100644 --- a/src/library.cpp +++ b/src/library.cpp @@ -1749,6 +1749,7 @@ void *lammps_extract_compute(void *handle, const char *id, int style, int type) if (type == LMP_TYPE_SCALAR) return (void *) &compute->size_local_rows; /* for backward compatibility */ if (type == LMP_TYPE_VECTOR) return (void *) compute->vector_local; if (type == LMP_TYPE_ARRAY) return (void *) compute->array_local; + if (type == LMP_SIZE_VECTOR) return (void *) &compute->size_local_rows; /* alias for LMP_SIZE_ROWS */ if (type == LMP_SIZE_ROWS) return (void *) &compute->size_local_rows; if (type == LMP_SIZE_COLS) return (void *) &compute->size_local_cols; } From ffc5b12c5fcd97dccf7e4321c3a450be1d326fda Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 20 Jun 2022 18:10:57 -0400 Subject: [PATCH 410/585] correct handling data of local computes which always needs to check rows and cols --- python/lammps/numpy_wrapper.py | 9 ++++++++- 1 file changed, 8 insertions(+), 1 deletion(-) diff --git a/python/lammps/numpy_wrapper.py b/python/lammps/numpy_wrapper.py index 3619728081..ce0cb35e47 100644 --- a/python/lammps/numpy_wrapper.py +++ b/python/lammps/numpy_wrapper.py @@ -165,7 +165,7 @@ class numpy_wrapper: """ value = self.lmp.extract_compute(cid, cstyle, ctype) - if cstyle in (LMP_STYLE_GLOBAL, LMP_STYLE_LOCAL): + if cstyle == LMP_STYLE_GLOBAL: if ctype == LMP_TYPE_VECTOR: nrows = self.lmp.extract_compute(cid, cstyle, LMP_SIZE_VECTOR) return self.darray(value, nrows) @@ -173,6 +173,13 @@ class numpy_wrapper: nrows = self.lmp.extract_compute(cid, cstyle, LMP_SIZE_ROWS) ncols = self.lmp.extract_compute(cid, cstyle, LMP_SIZE_COLS) return self.darray(value, nrows, ncols) + elif cstyle == LMP_STYLE_LOCAL: + nrows = self.lmp.extract_compute(cid, cstyle, LMP_SIZE_ROWS) + ncols = self.lmp.extract_compute(cid, cstyle, LMP_SIZE_COLS) + if ncols == 0: + return self.darray(value, nrows) + else: + return self.darray(value, nrows, ncols) elif cstyle == LMP_STYLE_ATOM: if ctype == LMP_TYPE_VECTOR: nlocal = self.lmp.extract_global("nlocal") From ac615059a7aa85643e378bcb85f8b5e7cf764c72 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 20 Jun 2022 18:15:02 -0400 Subject: [PATCH 411/585] update some linewraps for 100 col limit --- python/lammps/core.py | 37 +++++++++++++------------------------ 1 file changed, 13 insertions(+), 24 deletions(-) diff --git a/python/lammps/core.py b/python/lammps/core.py index 23002b210c..930a40a4b0 100644 --- a/python/lammps/core.py +++ b/python/lammps/core.py @@ -188,20 +188,17 @@ class lammps(object): [c_void_p,POINTER(c_double),POINTER(c_double),c_double,c_double,c_double] self.lib.lammps_reset_box.restype = None - self.lib.lammps_gather_atoms.argtypes = \ - [c_void_p,c_char_p,c_int,c_int,c_void_p] + self.lib.lammps_gather_atoms.argtypes = [c_void_p,c_char_p,c_int,c_int,c_void_p] self.lib.lammps_gather_atoms.restype = None - self.lib.lammps_gather_atoms_concat.argtypes = \ - [c_void_p,c_char_p,c_int,c_int,c_void_p] + self.lib.lammps_gather_atoms_concat.argtypes = [c_void_p,c_char_p,c_int,c_int,c_void_p] self.lib.lammps_gather_atoms_concat.restype = None self.lib.lammps_gather_atoms_subset.argtypes = \ [c_void_p,c_char_p,c_int,c_int,c_int,POINTER(c_int),c_void_p] self.lib.lammps_gather_atoms_subset.restype = None - self.lib.lammps_scatter_atoms.argtypes = \ - [c_void_p,c_char_p,c_int,c_int,c_void_p] + self.lib.lammps_scatter_atoms.argtypes = [c_void_p,c_char_p,c_int,c_int,c_void_p] self.lib.lammps_scatter_atoms.restype = None self.lib.lammps_scatter_atoms_subset.argtypes = \ @@ -211,20 +208,17 @@ class lammps(object): self.lib.lammps_gather_bonds.argtypes = [c_void_p,c_void_p] self.lib.lammps_gather_bonds.restype = None - self.lib.lammps_gather.argtypes = \ - [c_void_p,c_char_p,c_int,c_int,c_void_p] + self.lib.lammps_gather.argtypes = [c_void_p,c_char_p,c_int,c_int,c_void_p] self.lib.lammps_gather.restype = None - self.lib.lammps_gather_concat.argtypes = \ - [c_void_p,c_char_p,c_int,c_int,c_void_p] + self.lib.lammps_gather_concat.argtypes = [c_void_p,c_char_p,c_int,c_int,c_void_p] self.lib.lammps_gather_concat.restype = None self.lib.lammps_gather_subset.argtypes = \ [c_void_p,c_char_p,c_int,c_int,c_int,POINTER(c_int),c_void_p] self.lib.lammps_gather_subset.restype = None - self.lib.lammps_scatter.argtypes = \ - [c_void_p,c_char_p,c_int,c_int,c_void_p] + self.lib.lammps_scatter.argtypes = [c_void_p,c_char_p,c_int,c_int,c_void_p] self.lib.lammps_scatter.restype = None self.lib.lammps_scatter_subset.argtypes = \ @@ -244,7 +238,8 @@ class lammps(object): self.lib.lammps_neighlist_num_elements.argtypes = [c_void_p, c_int] self.lib.lammps_neighlist_num_elements.restype = c_int - self.lib.lammps_neighlist_element_neighbors.argtypes = [c_void_p, c_int, c_int, POINTER(c_int), POINTER(c_int), POINTER(POINTER(c_int))] + self.lib.lammps_neighlist_element_neighbors.argtypes = \ + [c_void_p, c_int, c_int, POINTER(c_int), POINTER(c_int), POINTER(POINTER(c_int))] self.lib.lammps_neighlist_element_neighbors.restype = None self.lib.lammps_is_running.argtypes = [c_void_p] @@ -368,11 +363,9 @@ class lammps(object): if type(cmdargs[i]) is str: cmdargs[i] = cmdargs[i].encode() cargs = (c_char_p*narg)(*cmdargs) - self.lib.lammps_open.argtypes = [c_int, c_char_p*narg, \ - MPI_Comm, c_void_p] + self.lib.lammps_open.argtypes = [c_int, c_char_p*narg, MPI_Comm, c_void_p] else: - self.lib.lammps_open.argtypes = [c_int, c_char_p, \ - MPI_Comm, c_void_p] + self.lib.lammps_open.argtypes = [c_int, c_char_p, MPI_Comm, c_void_p] self.opened = 1 comm_ptr = self.MPI._addressof(comm) @@ -390,8 +383,7 @@ class lammps(object): if type(cmdargs[i]) is str: cmdargs[i] = cmdargs[i].encode() cargs = (c_char_p*narg)(*cmdargs) - self.lib.lammps_open_no_mpi.argtypes = [c_int, c_char_p*narg, \ - c_void_p] + self.lib.lammps_open_no_mpi.argtypes = [c_int, c_char_p*narg, c_void_p] self.lmp = c_void_p(self.lib.lammps_open_no_mpi(narg,cargs,None)) else: self.lib.lammps_open_no_mpi.argtypes = [c_int, c_char_p, c_void_p] @@ -963,17 +955,14 @@ class lammps(object): return ptr elif ctype == LMP_SIZE_COLS: - if cstyle == LMP_STYLE_GLOBAL \ - or cstyle == LMP_STYLE_ATOM \ - or cstyle == LMP_STYLE_LOCAL: + if cstyle == LMP_STYLE_GLOBAL or cstyle == LMP_STYLE_ATOM or cstyle == LMP_STYLE_LOCAL: self.lib.lammps_extract_compute.restype = POINTER(c_int) with ExceptionCheck(self): ptr = self.lib.lammps_extract_compute(self.lmp,cid,cstyle,ctype) return ptr[0] elif ctype == LMP_SIZE_VECTOR or ctype == LMP_SIZE_ROWS: - if cstyle == LMP_STYLE_GLOBAL \ - or cstyle == LMP_STYLE_LOCAL: + if cstyle == LMP_STYLE_GLOBAL or cstyle == LMP_STYLE_LOCAL: self.lib.lammps_extract_compute.restype = POINTER(c_int) with ExceptionCheck(self): ptr = self.lib.lammps_extract_compute(self.lmp,cid,cstyle,ctype) From 78129f9078b39b97bcc0c1601ef7dd3d1de4ebd1 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 20 Jun 2022 18:23:20 -0400 Subject: [PATCH 412/585] update embedded docs for LMP_SIZE_VECTOR update for extract_compute() --- src/library.cpp | 8 ++++++-- 1 file changed, 6 insertions(+), 2 deletions(-) diff --git a/src/library.cpp b/src/library.cpp index de655d74d0..cdc0a812c5 100644 --- a/src/library.cpp +++ b/src/library.cpp @@ -1659,14 +1659,18 @@ lists the available options. - LMP_TYPE_ARRAY - ``double **`` - Local data array + * - LMP_STYLE_LOCAL + - LMP_SIZE_VECTOR + - ``int *`` + - Alias for using LMP_SIZE_ROWS * - LMP_STYLE_LOCAL - LMP_SIZE_ROWS - ``int *`` - - Number of local data rows + - Number of local array rows or length of vector * - LMP_STYLE_LOCAL - LMP_SIZE_COLS - ``int *`` - - Number of local data columns + - Number of local array columns, 0 if vector .. warning:: From 033af0c507b4be72ef9cdfb240aa0dc34762fb50 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 20 Jun 2022 18:48:50 -0400 Subject: [PATCH 413/585] add unit test for extracting local vector and array via numpy --- unittest/python/python-numpy.py | 38 ++++++++++++++++++++++++++------- 1 file changed, 30 insertions(+), 8 deletions(-) diff --git a/unittest/python/python-numpy.py b/unittest/python/python-numpy.py index 010255a81e..7cbae8e48d 100644 --- a/unittest/python/python-numpy.py +++ b/unittest/python/python-numpy.py @@ -93,17 +93,39 @@ class PythonNumpy(unittest.TestCase): # TODO pass - def testExtractComputeLocalScalar(self): - # TODO - pass - def testExtractComputeLocalVector(self): - # TODO - pass + self.lmp.command("region box block 0 2 0 2 0 2") + self.lmp.command("create_box 1 box") + self.lmp.command("create_atoms 1 single 1.0 1.0 1.0") + self.lmp.command("create_atoms 1 single 1.0 1.0 1.5") + self.lmp.command("mass 1 1.0") + self.lmp.command("pair_style lj/cut 1.9") + self.lmp.command("pair_coeff 1 1 1.0 1.0") + self.lmp.command("compute r0 all pair/local dist") + self.lmp.command("run 0 post no") + values = self.lmp.numpy.extract_compute("r0", LMP_STYLE_LOCAL, LMP_TYPE_VECTOR) + self.assertEqual(values.ndim, 1) + self.assertEqual(values.size, 2) + self.assertEqual(values[0], 0.5) + self.assertEqual(values[1], 1.5) def testExtractComputeLocalArray(self): - # TODO - pass + self.lmp.command("region box block 0 2 0 2 0 2") + self.lmp.command("create_box 1 box") + self.lmp.command("create_atoms 1 single 1.0 1.0 1.0") + self.lmp.command("create_atoms 1 single 1.0 1.0 1.5") + self.lmp.command("mass 1 1.0") + self.lmp.command("pair_style lj/cut 1.9") + self.lmp.command("pair_coeff 1 1 1.0 1.0") + self.lmp.command("compute r0 all pair/local dist dx dy dz") + self.lmp.command("run 0 post no") + values = self.lmp.numpy.extract_compute("r0", LMP_STYLE_LOCAL, LMP_TYPE_ARRAY) + self.assertEqual(values.ndim, 2) + self.assertEqual(values.size, 8) + self.assertEqual(values[0,0], 0.5) + self.assertEqual(values[0,3], -0.5) + self.assertEqual(values[1,0], 1.5) + self.assertEqual(values[1,3], 1.5) def testExtractAtomDeprecated(self): self.lmp.command("units lj") From ec46510d2e33e09cd23641ec0a3dcb9b0d35017a Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 20 Jun 2022 23:07:01 -0400 Subject: [PATCH 414/585] add local extract_compute() tests --- unittest/python/python-commands.py | 12 +++++++++++- 1 file changed, 11 insertions(+), 1 deletion(-) diff --git a/unittest/python/python-commands.py b/unittest/python/python-commands.py index 58a0772510..cd77fa21a1 100644 --- a/unittest/python/python-commands.py +++ b/unittest/python/python-commands.py @@ -1,6 +1,8 @@ import sys,os,unittest,ctypes -from lammps import lammps, LMP_VAR_ATOM, LMP_STYLE_GLOBAL, LMP_TYPE_VECTOR, LAMMPS_DOUBLE_2D, LAMMPS_AUTODETECT +from lammps import lammps, LMP_VAR_ATOM, LMP_STYLE_GLOBAL, LMP_STYLE_LOCAL +from lammps import LMP_TYPE_VECTOR, LMP_SIZE_VECTOR, LMP_SIZE_ROWS, LMP_SIZE_COLS +from lammps import LAMMPS_DOUBLE_2D, LAMMPS_AUTODETECT has_manybody=False try: @@ -311,6 +313,14 @@ create_atoms 1 single & self.assertEqual(minval,1.0) self.assertEqual(maxval,2.1) + ndist1 = self.lmp.extract_compute("dist",LMP_STYLE_LOCAL,LMP_SIZE_VECTOR) + ndist2 = self.lmp.extract_compute("dist",LMP_STYLE_LOCAL,LMP_SIZE_ROWS) + ndist3 = self.lmp.extract_compute("dist",LMP_STYLE_LOCAL,LMP_SIZE_COLS) + + self.assertEqual(ndist1,21) + self.assertEqual(ndist2,21) + self.assertEqual(ndist3,0) + self.assertNotEqual(self.lmp.find_pair_neighlist("lj/cut"),-1) self.assertNotEqual(self.lmp.find_compute_neighlist("dist"),-1) self.assertEqual(self.lmp.find_compute_neighlist("xxx"),-1) From ad20e54638cfb2a70f529c56090a2c7035b50022 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 20 Jun 2022 23:19:00 -0400 Subject: [PATCH 415/585] fix typos --- tools/msi2lmp/src/msi2lmp.c | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/tools/msi2lmp/src/msi2lmp.c b/tools/msi2lmp/src/msi2lmp.c index 87cffb4e6e..3136678023 100644 --- a/tools/msi2lmp/src/msi2lmp.c +++ b/tools/msi2lmp/src/msi2lmp.c @@ -66,9 +66,9 @@ * The program is started by supplying information at the command prompt * according to the usage described below. * -* USAGE: msi2lmp3 ROOTNAME {-print #} {-class #} {-frc FRC_FILE} {-ignore} {-nocenter} {-oldstyle} +* USAGE: msi2lmp ROOTNAME {-print #} {-class #} {-frc FRC_FILE} {-ignore} {-nocenter} {-oldstyle} * -* -- msi2lmp3 is the name of the executable +* -- msi2lmp is the name of the executable * -- ROOTNAME is the base name of the .car and .mdf files * -- all opther flags are optional and can be abbreviated (e.g. -p instead of -print) * From 6815b27cd5436ddc5484229004aeb019e3b0a2e0 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 21 Jun 2022 08:52:11 -0400 Subject: [PATCH 416/585] step version strings for the next patch release --- doc/lammps.1 | 4 ++-- src/version.h | 2 +- 2 files changed, 3 insertions(+), 3 deletions(-) diff --git a/doc/lammps.1 b/doc/lammps.1 index cfeb23aadb..5f1c25867e 100644 --- a/doc/lammps.1 +++ b/doc/lammps.1 @@ -1,7 +1,7 @@ -.TH LAMMPS "1" "2 June 2022" "2022-6-2" +.TH LAMMPS "1" "23 June 2022" "2022-6-23" .SH NAME .B LAMMPS -\- Molecular Dynamics Simulator. Version 2 June 2022 +\- Molecular Dynamics Simulator. Version 23 June 2022 .SH SYNOPSIS .B lmp diff --git a/src/version.h b/src/version.h index 60ed7ad75f..4b95d1c910 100644 --- a/src/version.h +++ b/src/version.h @@ -1 +1 @@ -#define LAMMPS_VERSION "2 Jun 2022" +#define LAMMPS_VERSION "23 Jun 2022" From f4342ea7e40feaa7196ab8bbd01d54a3b7fd7dcc Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Tue, 21 Jun 2022 15:03:22 -0600 Subject: [PATCH 417/585] use new version of MDI lib and include Python support --- lib/mdi/Install.py | 2 +- lib/mdi/Makefile.gcc | 2 +- lib/mdi/Makefile.icc | 2 +- lib/mdi/Makefile.mpi | 2 +- 4 files changed, 4 insertions(+), 4 deletions(-) diff --git a/lib/mdi/Install.py b/lib/mdi/Install.py index a439da34d2..48d4952f9b 100644 --- a/lib/mdi/Install.py +++ b/lib/mdi/Install.py @@ -34,7 +34,7 @@ make lib-meam args="-m ifort" # build MEAM lib with custom Makefile.ifort (usi # settings -version = "1.3.2" +version = "1.4.1" url = "https://github.com/MolSSI-MDI/MDI_Library/archive/v%s.tar.gz" % version # known checksums for different MDI versions. used to validate the download. diff --git a/lib/mdi/Makefile.gcc b/lib/mdi/Makefile.gcc index ef8a96f5ad..a67209202b 100644 --- a/lib/mdi/Makefile.gcc +++ b/lib/mdi/Makefile.gcc @@ -8,7 +8,7 @@ EXTRAMAKE = Makefile.lammps.empty lib: $(OBJ) mkdir -p build - cd build; cmake -Dlibtype=SHARED -Dlanguage=C -D CMAKE_C_COMPILER=gcc ../MDI_Library; make + cd build; cmake -Dlibtype=SHARED -D CMAKE_C_COMPILER=gcc ../MDI_Library; make @cp $(EXTRAMAKE) Makefile.lammps # ------ CLEAN ------ diff --git a/lib/mdi/Makefile.icc b/lib/mdi/Makefile.icc index d70ff28f97..eac6ba087f 100644 --- a/lib/mdi/Makefile.icc +++ b/lib/mdi/Makefile.icc @@ -8,7 +8,7 @@ EXTRAMAKE = Makefile.lammps.empty lib: $(OBJ) mkdir -p build - cd build; cmake -Dlibtype=SHARED -Dlanguage=C -D CMAKE_C_COMPILER=icc -D CMAKE_CXX_COMPILER=icc ../MDI_Library; make + cd build; cmake -Dlibtype=SHARED -D CMAKE_C_COMPILER=icc -D CMAKE_CXX_COMPILER=icc ../MDI_Library; make @cp $(EXTRAMAKE) Makefile.lammps # ------ CLEAN ------ diff --git a/lib/mdi/Makefile.mpi b/lib/mdi/Makefile.mpi index cff60f5e0b..0a40520c95 100644 --- a/lib/mdi/Makefile.mpi +++ b/lib/mdi/Makefile.mpi @@ -8,7 +8,7 @@ EXTRAMAKE = Makefile.lammps.empty lib: $(OBJ) mkdir -p build - cd build; cmake -Dlibtype=SHARED -Dlanguage=CXX -D CMAKE_C_COMPILER=mpicc -D CMAKE_CXX_COMPILER=mpicxx ../MDI_Library; make + cd build; cmake -Dlibtype=SHARED -D CMAKE_C_COMPILER=mpicc -D CMAKE_CXX_COMPILER=mpicxx ../MDI_Library; make @cp $(EXTRAMAKE) Makefile.lammps # ------ CLEAN ------ From 7d49ad5924d3d3121983f2d57b2ac86395f0b96e Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 21 Jun 2022 19:30:42 -0400 Subject: [PATCH 418/585] enable remap for restarting by default, add noremap option --- src/read_restart.cpp | 8 ++++---- 1 file changed, 4 insertions(+), 4 deletions(-) diff --git a/src/read_restart.cpp b/src/read_restart.cpp index b42dcce1ca..a7fb5a828d 100644 --- a/src/read_restart.cpp +++ b/src/read_restart.cpp @@ -61,9 +61,10 @@ void ReadRestart::command(int narg, char **arg) // check for remap option - int remapflag = 0; + int remapflag = 1; if (narg == 2) { - if (strcmp(arg[1],"remap") == 0) remapflag = 1; + if (strcmp(arg[1],"noremap") == 0) remapflag = 0; + else if (strcmp(arg[1],"remap") == 0) remapflag = 1; // for backward compatibility else error->all(FLERR,"Illegal read_restart command"); } @@ -643,8 +644,7 @@ void ReadRestart::header() int dimension = read_int(); domain->dimension = dimension; if (domain->dimension == 2 && domain->zperiodic == 0) - error->all(FLERR, - "Cannot run 2d simulation with non-periodic Z dimension"); + error->all(FLERR, "Cannot run 2d simulation with non-periodic Z dimension"); // read nprocs from restart file, warn if different From b0f4ef8a39f684b5663071ad45c48b789bce723a Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 21 Jun 2022 20:19:13 -0400 Subject: [PATCH 419/585] update docs for noremap option to read_restart --- doc/src/read_restart.rst | 67 ++++++++++----------- doc/utils/sphinx-config/false_positives.txt | 1 + 2 files changed, 34 insertions(+), 34 deletions(-) diff --git a/doc/src/read_restart.rst b/doc/src/read_restart.rst index 4d68167560..b593fd51ae 100644 --- a/doc/src/read_restart.rst +++ b/doc/src/read_restart.rst @@ -11,7 +11,7 @@ Syntax read_restart file flag * file = name of binary restart file to read in -* flag = remap (optional) +* flag = noremap (optional) Examples """""""" @@ -19,39 +19,36 @@ Examples .. code-block:: LAMMPS read_restart save.10000 - read_restart save.10000 remap + read_restart save.10000 noremap read_restart restart.* read_restart restart.*.mpiio - read_restart poly.*.% remap + read_restart poly.*.% noremap Description """"""""""" Read in a previously saved system configuration from a restart file. This allows continuation of a previous run. Details about what -information is stored (and not stored) in a restart file is given -below. Basically this operation will re-create the simulation box -with all its atoms and their attributes as well as some related global -settings, at the point in time it was written to the restart file by a -previous simulation. The simulation box will be partitioned into a -regular 3d grid of rectangular bricks, one per processor, based on the -number of processors in the current simulation and the settings of the +information is stored (and not stored) in a restart file is given below. +Basically this operation will re-create the simulation box with all its +atoms and their attributes as well as some related global settings, at +the point in time it was written to the restart file by a previous +simulation. The simulation box will be partitioned into a regular 3d +grid of rectangular bricks, one per processor, based on the number of +processors in the current simulation and the settings of the :doc:`processors ` command. The partitioning can later be -changed by the :doc:`balance ` or :doc:`fix balance ` commands. +changed by the :doc:`balance ` or :doc:`fix balance +` commands. .. note:: - Normally, restart files are written by the - :doc:`restart ` or :doc:`write_restart ` commands - so that all atoms in the restart file are inside the simulation box. - If this is not the case, the read_restart command will print an error - that atoms were "lost" when the file is read. This error should be - reported to the LAMMPS developers so the invalid writing of the - restart file can be fixed. If you still wish to use the restart file, - the optional *remap* flag can be appended to the read_restart command. - This should avoid the error, by explicitly remapping each atom back - into the simulation box, updating image flags for the atom - appropriately. + When restart files are read, atoms are explicitly remapped back into + the simulation box and image flags updated accordingly. In most + cases this will not make a difference since writing a restart file + will also trigger a rebuild of the neighbor lists and remapping of + atoms into the simulation box. This extra remap results in some + overhead that can be avoided by appending the optional *noremap* flag + to the read_restart command. Restart files are saved in binary format to enable exact restarts, meaning that the trajectories of a restarted run will precisely match @@ -65,7 +62,8 @@ certain settings such as those set by the :doc:`newton ` or these cases. Certain fixes will not restart exactly, though they should provide -statistically similar results. These include :doc:`fix shake ` and :doc:`fix langevin `. +statistically similar results. These include :doc:`fix shake +` and :doc:`fix langevin `. Certain pair styles will not restart exactly, though they should provide statistically similar results. This is because the forces @@ -81,18 +79,19 @@ produced the restart file, it could be a LAMMPS bug, so consider :doc:`reporting it ` if you think the behavior is a bug. Because restart files are binary, they may not be portable to other -machines. In this case, you can use the :doc:`-restart command-line switch ` to convert a restart file to a data file. +machines. In this case, you can use the :doc:`-restart command-line +switch ` to convert a restart file to a data file. -Similar to how restart files are written (see the -:doc:`write_restart ` and :doc:`restart ` -commands), the restart filename can contain two wild-card characters. -If a "\*" appears in the filename, the directory is searched for all -filenames that match the pattern where "\*" is replaced with a timestep -value. The file with the largest timestep value is read in. Thus, -this effectively means, read the latest restart file. It's useful if -you want your script to continue a run from where it left off. See -the :doc:`run ` command and its "upto" option for how to specify -the run command so it does not need to be changed either. +Similar to how restart files are written (see the :doc:`write_restart +` and :doc:`restart ` commands), the restart +filename can contain two wild-card characters. If a "\*" appears in the +filename, the directory is searched for all filenames that match the +pattern where "\*" is replaced with a timestep value. The file with the +largest timestep value is read in. Thus, this effectively means, read +the latest restart file. It's useful if you want your script to +continue a run from where it left off. See the :doc:`run ` command +and its "upto" option for how to specify the run command so it does not +need to be changed either. If a "%" character appears in the restart filename, LAMMPS expects a set of multiple files to exist. The :doc:`restart ` and diff --git a/doc/utils/sphinx-config/false_positives.txt b/doc/utils/sphinx-config/false_positives.txt index b42cff262a..cce6e92d05 100644 --- a/doc/utils/sphinx-config/false_positives.txt +++ b/doc/utils/sphinx-config/false_positives.txt @@ -2369,6 +2369,7 @@ nopreliminary Nord norder Nordlund +noremap normals normx normy From b0c673d8564629f35c1ed9de081ca1837536c83f Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 21 Jun 2022 20:37:20 -0400 Subject: [PATCH 420/585] updates from Karl Hammond to adjust his email and correct an error message --- examples/COUPLE/fortran2/LAMMPS-wrapper.cpp | 4 ++-- examples/COUPLE/fortran2/LAMMPS-wrapper.h | 4 ++-- examples/COUPLE/fortran2/LAMMPS.F90 | 2 +- examples/COUPLE/fortran2/README | 5 ++--- examples/COUPLE/fortran_dftb/LAMMPS-wrapper.cpp | 4 ++-- examples/COUPLE/fortran_dftb/LAMMPS-wrapper.h | 4 ++-- examples/COUPLE/fortran_dftb/LAMMPS-wrapper2.cpp | 4 ++-- examples/COUPLE/fortran_dftb/LAMMPS.F90 | 4 ++-- 8 files changed, 15 insertions(+), 16 deletions(-) diff --git a/examples/COUPLE/fortran2/LAMMPS-wrapper.cpp b/examples/COUPLE/fortran2/LAMMPS-wrapper.cpp index 8b6a257755..b5b265b4dd 100644 --- a/examples/COUPLE/fortran2/LAMMPS-wrapper.cpp +++ b/examples/COUPLE/fortran2/LAMMPS-wrapper.cpp @@ -12,8 +12,8 @@ ------------------------------------------------------------------------- */ /* ------------------------------------------------------------------------ - Contributing author: Karl D. Hammond - University of Tennessee, Knoxville (USA), 2012 + Contributing author: Karl D. Hammond + University of Missouri (USA), 2012 ------------------------------------------------------------------------- */ /* This is set of "wrapper" functions to assist LAMMPS.F90, which itself diff --git a/examples/COUPLE/fortran2/LAMMPS-wrapper.h b/examples/COUPLE/fortran2/LAMMPS-wrapper.h index 68e03ae05a..479af91738 100644 --- a/examples/COUPLE/fortran2/LAMMPS-wrapper.h +++ b/examples/COUPLE/fortran2/LAMMPS-wrapper.h @@ -12,8 +12,8 @@ ------------------------------------------------------------------------- */ /* ------------------------------------------------------------------------ - Contributing author: Karl D. Hammond - University of Tennessee, Knoxville (USA), 2012 + Contributing author: Karl D. Hammond + University of Missouri (USA), 2012 ------------------------------------------------------------------------- */ /* This is set of "wrapper" functions to assist LAMMPS.F90, which itself diff --git a/examples/COUPLE/fortran2/LAMMPS.F90 b/examples/COUPLE/fortran2/LAMMPS.F90 index 8b74a38721..65ea83e245 100644 --- a/examples/COUPLE/fortran2/LAMMPS.F90 +++ b/examples/COUPLE/fortran2/LAMMPS.F90 @@ -1292,7 +1292,7 @@ contains !! Wrapper functions local to this module {{{1 Cname = string2Cstring (name) Ccount = size(data) / natoms if ( Ccount /= 1 .and. Ccount /= 3 ) & - call lammps_error_all (ptr, FLERR, 'lammps_gather_atoms requires& + call lammps_error_all (ptr, FLERR, 'lammps_scatter_atoms requires& & count to be either 1 or 3') Fdata = data Cdata = C_loc (Fdata(1)) diff --git a/examples/COUPLE/fortran2/README b/examples/COUPLE/fortran2/README index 1710ca8ba6..0a7b862d86 100644 --- a/examples/COUPLE/fortran2/README +++ b/examples/COUPLE/fortran2/README @@ -11,9 +11,8 @@ This interface was created by Karl Hammond who you can contact with questions: Karl D. Hammond -University of Tennessee, Knoxville -karlh at ugcs.caltech.edu -karlh at utk.edu +University of Missouri +hammondkd at missouri.edu ------------------------------------- diff --git a/examples/COUPLE/fortran_dftb/LAMMPS-wrapper.cpp b/examples/COUPLE/fortran_dftb/LAMMPS-wrapper.cpp index 8b6a257755..b5b265b4dd 100644 --- a/examples/COUPLE/fortran_dftb/LAMMPS-wrapper.cpp +++ b/examples/COUPLE/fortran_dftb/LAMMPS-wrapper.cpp @@ -12,8 +12,8 @@ ------------------------------------------------------------------------- */ /* ------------------------------------------------------------------------ - Contributing author: Karl D. Hammond - University of Tennessee, Knoxville (USA), 2012 + Contributing author: Karl D. Hammond + University of Missouri (USA), 2012 ------------------------------------------------------------------------- */ /* This is set of "wrapper" functions to assist LAMMPS.F90, which itself diff --git a/examples/COUPLE/fortran_dftb/LAMMPS-wrapper.h b/examples/COUPLE/fortran_dftb/LAMMPS-wrapper.h index 7d94362436..553466d138 100644 --- a/examples/COUPLE/fortran_dftb/LAMMPS-wrapper.h +++ b/examples/COUPLE/fortran_dftb/LAMMPS-wrapper.h @@ -12,8 +12,8 @@ ------------------------------------------------------------------------- */ /* ------------------------------------------------------------------------ - Contributing author: Karl D. Hammond - University of Tennessee, Knoxville (USA), 2012 + Contributing author: Karl D. Hammond + University of Missouri (USA), 2012 ------------------------------------------------------------------------- */ /* This is set of "wrapper" functions to assist LAMMPS.F90, which itself diff --git a/examples/COUPLE/fortran_dftb/LAMMPS-wrapper2.cpp b/examples/COUPLE/fortran_dftb/LAMMPS-wrapper2.cpp index 5f94363346..605735a2b7 100644 --- a/examples/COUPLE/fortran_dftb/LAMMPS-wrapper2.cpp +++ b/examples/COUPLE/fortran_dftb/LAMMPS-wrapper2.cpp @@ -12,8 +12,8 @@ ------------------------------------------------------------------------- */ /* ------------------------------------------------------------------------ - Contributing author: Karl D. Hammond - University of Tennessee, Knoxville (USA), 2012 + Contributing author: Karl D. Hammond + University of Missouri (USA), 2012 ------------------------------------------------------------------------- */ /* This is set of "wrapper" functions to assist LAMMPS.F90, which itself diff --git a/examples/COUPLE/fortran_dftb/LAMMPS.F90 b/examples/COUPLE/fortran_dftb/LAMMPS.F90 index 9b18bbfa5f..188fff9d60 100644 --- a/examples/COUPLE/fortran_dftb/LAMMPS.F90 +++ b/examples/COUPLE/fortran_dftb/LAMMPS.F90 @@ -12,8 +12,8 @@ !-------------------------------------------------------------------------- !! ------------------------------------------------------------------------ -! Contributing author: Karl D. Hammond -! University of Tennessee, Knoxville (USA), 2012 +! Contributing author: Karl D. Hammond +! University of Missouri (USA), 2012 !-------------------------------------------------------------------------- !! LAMMPS, a Fortran 2003 module containing an interface between Fortran From c0b109f715b08eb05535fcc318a0db19b7b3b06b Mon Sep 17 00:00:00 2001 From: Karl Hammond Date: Tue, 21 Jun 2022 20:53:45 -0500 Subject: [PATCH 421/585] Fixed some typos and updated e-mail addresses in examples/COUPLE/fortran2 --- examples/COUPLE/fortran2/LAMMPS-wrapper.cpp | 2 +- examples/COUPLE/fortran2/LAMMPS-wrapper.h | 2 +- examples/COUPLE/fortran2/LAMMPS.F90 | 4 ++-- examples/COUPLE/fortran2/README | 5 ++--- 4 files changed, 6 insertions(+), 7 deletions(-) diff --git a/examples/COUPLE/fortran2/LAMMPS-wrapper.cpp b/examples/COUPLE/fortran2/LAMMPS-wrapper.cpp index 8b6a257755..fb8c67ecc9 100644 --- a/examples/COUPLE/fortran2/LAMMPS-wrapper.cpp +++ b/examples/COUPLE/fortran2/LAMMPS-wrapper.cpp @@ -12,7 +12,7 @@ ------------------------------------------------------------------------- */ /* ------------------------------------------------------------------------ - Contributing author: Karl D. Hammond + Contributing author: Karl D. Hammond University of Tennessee, Knoxville (USA), 2012 ------------------------------------------------------------------------- */ diff --git a/examples/COUPLE/fortran2/LAMMPS-wrapper.h b/examples/COUPLE/fortran2/LAMMPS-wrapper.h index 68e03ae05a..a1e5fcdd1f 100644 --- a/examples/COUPLE/fortran2/LAMMPS-wrapper.h +++ b/examples/COUPLE/fortran2/LAMMPS-wrapper.h @@ -12,7 +12,7 @@ ------------------------------------------------------------------------- */ /* ------------------------------------------------------------------------ - Contributing author: Karl D. Hammond + Contributing author: Karl D. Hammond University of Tennessee, Knoxville (USA), 2012 ------------------------------------------------------------------------- */ diff --git a/examples/COUPLE/fortran2/LAMMPS.F90 b/examples/COUPLE/fortran2/LAMMPS.F90 index 8b74a38721..251b56f48f 100644 --- a/examples/COUPLE/fortran2/LAMMPS.F90 +++ b/examples/COUPLE/fortran2/LAMMPS.F90 @@ -1292,7 +1292,7 @@ contains !! Wrapper functions local to this module {{{1 Cname = string2Cstring (name) Ccount = size(data) / natoms if ( Ccount /= 1 .and. Ccount /= 3 ) & - call lammps_error_all (ptr, FLERR, 'lammps_gather_atoms requires& + call lammps_error_all (ptr, FLERR, 'lammps_scatter_atoms requires& & count to be either 1 or 3') Fdata = data Cdata = C_loc (Fdata(1)) @@ -1355,7 +1355,7 @@ contains !! Wrapper functions local to this module {{{1 Cname = string2Cstring (name) Ccount = size(data) / ndata if ( Ccount /= 1 .and. Ccount /= 3 ) & - call lammps_error_all (ptr, FLERR, 'lammps_gather_atoms requires& + call lammps_error_all (ptr, FLERR, 'lammps_scatter_atoms requires& & count to be either 1 or 3') Fdata = data Cdata = C_loc (Fdata(1)) diff --git a/examples/COUPLE/fortran2/README b/examples/COUPLE/fortran2/README index 1710ca8ba6..0a7b862d86 100644 --- a/examples/COUPLE/fortran2/README +++ b/examples/COUPLE/fortran2/README @@ -11,9 +11,8 @@ This interface was created by Karl Hammond who you can contact with questions: Karl D. Hammond -University of Tennessee, Knoxville -karlh at ugcs.caltech.edu -karlh at utk.edu +University of Missouri +hammondkd at missouri.edu ------------------------------------- From 49331be33e4aeb89b69a2056b26bfdc82ada6e46 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 22 Jun 2022 07:05:30 -0400 Subject: [PATCH 422/585] simplify --- examples/COUPLE/fortran2/LAMMPS-wrapper.cpp | 1 + examples/COUPLE/fortran2/Makefile | 2 +- examples/COUPLE/fortran_dftb/LAMMPS-wrapper.cpp | 1 + 3 files changed, 3 insertions(+), 1 deletion(-) diff --git a/examples/COUPLE/fortran2/LAMMPS-wrapper.cpp b/examples/COUPLE/fortran2/LAMMPS-wrapper.cpp index b5b265b4dd..1301bfe348 100644 --- a/examples/COUPLE/fortran2/LAMMPS-wrapper.cpp +++ b/examples/COUPLE/fortran2/LAMMPS-wrapper.cpp @@ -23,6 +23,7 @@ #include #include "LAMMPS-wrapper.h" +#define LAMMPS_LIB_MPI 1 #include #include #include diff --git a/examples/COUPLE/fortran2/Makefile b/examples/COUPLE/fortran2/Makefile index fe66914892..f8a2126233 100644 --- a/examples/COUPLE/fortran2/Makefile +++ b/examples/COUPLE/fortran2/Makefile @@ -14,7 +14,7 @@ CXXLIB = -lstdc++ # replace with your C++ runtime libs # Flags for Fortran compiler, C++ compiler, and C preprocessor, respectively FFLAGS = -O2 -fPIC CXXFLAGS = -O2 -fPIC -CPPFLAGS = -DOMPI_SKIP_MPICXX=1 -DMPICH_SKIP_MPICXX -DLAMMPS_LIB_MPI +CPPFLAGS = -DOMPI_SKIP_MPICXX=1 -DMPICH_SKIP_MPICXX all : liblammps_fortran.a liblammps_fortran.so diff --git a/examples/COUPLE/fortran_dftb/LAMMPS-wrapper.cpp b/examples/COUPLE/fortran_dftb/LAMMPS-wrapper.cpp index b5b265b4dd..1301bfe348 100644 --- a/examples/COUPLE/fortran_dftb/LAMMPS-wrapper.cpp +++ b/examples/COUPLE/fortran_dftb/LAMMPS-wrapper.cpp @@ -23,6 +23,7 @@ #include #include "LAMMPS-wrapper.h" +#define LAMMPS_LIB_MPI 1 #include #include #include From 37f056c45590d63005f495c1cdbf0a5d89454ec2 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 22 Jun 2022 07:06:00 -0400 Subject: [PATCH 423/585] get array and vector sizes from the avaiable APIs --- examples/COUPLE/fortran2/LAMMPS-wrapper.cpp | 177 ++---------------- .../COUPLE/fortran_dftb/LAMMPS-wrapper.cpp | 177 ++---------------- 2 files changed, 36 insertions(+), 318 deletions(-) diff --git a/examples/COUPLE/fortran2/LAMMPS-wrapper.cpp b/examples/COUPLE/fortran2/LAMMPS-wrapper.cpp index 1301bfe348..eb6f421606 100644 --- a/examples/COUPLE/fortran2/LAMMPS-wrapper.cpp +++ b/examples/COUPLE/fortran2/LAMMPS-wrapper.cpp @@ -57,181 +57,40 @@ void lammps_error_all (void *ptr, const char *file, int line, const char *str) int lammps_extract_compute_vectorsize (void *ptr, char *id, int style) { - class LAMMPS *lmp = (class LAMMPS *) ptr; - int icompute = lmp->modify->find_compute(id); - if ( icompute < 0 ) return 0; - class Compute *compute = lmp->modify->compute[icompute]; - - if ( style == 0 ) - { - if ( !compute->vector_flag ) - return 0; - else - return compute->size_vector; - } - else if ( style == 1 ) - { - return lammps_get_natoms (ptr); - } - else if ( style == 2 ) - { - if ( !compute->local_flag ) - return 0; - else - return compute->size_local_rows; - } - else - return 0; + int *size; + size = (int *) lammps_extract_compute(ptr, id, style, LMP_SIZE_VECTOR); + if (size) return *size; + return 0; } void lammps_extract_compute_arraysize (void *ptr, char *id, int style, int *nrows, int *ncols) { - class LAMMPS *lmp = (class LAMMPS *) ptr; - int icompute = lmp->modify->find_compute(id); - if ( icompute < 0 ) - { - *nrows = 0; - *ncols = 0; - } - class Compute *compute = lmp->modify->compute[icompute]; - - if ( style == 0 ) - { - if ( !compute->array_flag ) - { - *nrows = 0; - *ncols = 0; - } - else - { - *nrows = compute->size_array_rows; - *ncols = compute->size_array_cols; - } - } - else if ( style == 1 ) - { - if ( !compute->peratom_flag ) - { - *nrows = 0; - *ncols = 0; - } - else - { - *nrows = lammps_get_natoms (ptr); - *ncols = compute->size_peratom_cols; - } - } - else if ( style == 2 ) - { - if ( !compute->local_flag ) - { - *nrows = 0; - *ncols = 0; - } - else - { - *nrows = compute->size_local_rows; - *ncols = compute->size_local_cols; - } - } - else - { - *nrows = 0; - *ncols = 0; - } - + int *tmp; + tmp = (int *) lammps_extract_compute(ptr, id, style, LMP_SIZE_ROWS); + if (tmp) *nrows = *tmp; + tmp = (int *) lammps_extract_compute(ptr, id, style, LMP_SIZE_COLS); + if (tmp) *ncols = *tmp; return; } int lammps_extract_fix_vectorsize (void *ptr, char *id, int style) { - class LAMMPS *lmp = (class LAMMPS *) ptr; - int ifix = lmp->modify->find_fix(id); - if ( ifix < 0 ) return 0; - class Fix *fix = lmp->modify->fix[ifix]; - - if ( style == 0 ) - { - if ( !fix->vector_flag ) - return 0; - else - return fix->size_vector; - } - else if ( style == 1 ) - { - return lammps_get_natoms (ptr); - } - else if ( style == 2 ) - { - if ( !fix->local_flag ) - return 0; - else - return fix->size_local_rows; - } - else - return 0; + int *size; + size = (int *) lammps_extract_fix(ptr, id, style, LMP_SIZE_VECTOR, 0, 0); + if (size) return *size; + return 0; } void lammps_extract_fix_arraysize (void *ptr, char *id, int style, int *nrows, int *ncols) { - class LAMMPS *lmp = (class LAMMPS *) ptr; - int ifix = lmp->modify->find_fix(id); - if ( ifix < 0 ) - { - *nrows = 0; - *ncols = 0; - } - class Fix *fix = lmp->modify->fix[ifix]; - - if ( style == 0 ) - { - if ( !fix->array_flag ) - { - *nrows = 0; - *ncols = 0; - } - else - { - *nrows = fix->size_array_rows; - *ncols = fix->size_array_cols; - } - } - else if ( style == 1 ) - { - if ( !fix->peratom_flag ) - { - *nrows = 0; - *ncols = 0; - } - else - { - *nrows = lammps_get_natoms (ptr); - *ncols = fix->size_peratom_cols; - } - } - else if ( style == 2 ) - { - if ( !fix->local_flag ) - { - *nrows = 0; - *ncols = 0; - } - else - { - *nrows = fix->size_local_rows; - *ncols = fix->size_local_cols; - } - } - else - { - *nrows = 0; - *ncols = 0; - } - + int *tmp; + tmp = (int *) lammps_extract_fix(ptr, id, style, LMP_SIZE_ROWS, 0, 0); + if (tmp) *nrows = *tmp; + tmp = (int *) lammps_extract_fix(ptr, id, style, LMP_SIZE_COLS, 0, 0); + if (tmp) *ncols = *tmp; return; - } /* vim: set ts=3 sts=3 expandtab: */ diff --git a/examples/COUPLE/fortran_dftb/LAMMPS-wrapper.cpp b/examples/COUPLE/fortran_dftb/LAMMPS-wrapper.cpp index 1301bfe348..eb6f421606 100644 --- a/examples/COUPLE/fortran_dftb/LAMMPS-wrapper.cpp +++ b/examples/COUPLE/fortran_dftb/LAMMPS-wrapper.cpp @@ -57,181 +57,40 @@ void lammps_error_all (void *ptr, const char *file, int line, const char *str) int lammps_extract_compute_vectorsize (void *ptr, char *id, int style) { - class LAMMPS *lmp = (class LAMMPS *) ptr; - int icompute = lmp->modify->find_compute(id); - if ( icompute < 0 ) return 0; - class Compute *compute = lmp->modify->compute[icompute]; - - if ( style == 0 ) - { - if ( !compute->vector_flag ) - return 0; - else - return compute->size_vector; - } - else if ( style == 1 ) - { - return lammps_get_natoms (ptr); - } - else if ( style == 2 ) - { - if ( !compute->local_flag ) - return 0; - else - return compute->size_local_rows; - } - else - return 0; + int *size; + size = (int *) lammps_extract_compute(ptr, id, style, LMP_SIZE_VECTOR); + if (size) return *size; + return 0; } void lammps_extract_compute_arraysize (void *ptr, char *id, int style, int *nrows, int *ncols) { - class LAMMPS *lmp = (class LAMMPS *) ptr; - int icompute = lmp->modify->find_compute(id); - if ( icompute < 0 ) - { - *nrows = 0; - *ncols = 0; - } - class Compute *compute = lmp->modify->compute[icompute]; - - if ( style == 0 ) - { - if ( !compute->array_flag ) - { - *nrows = 0; - *ncols = 0; - } - else - { - *nrows = compute->size_array_rows; - *ncols = compute->size_array_cols; - } - } - else if ( style == 1 ) - { - if ( !compute->peratom_flag ) - { - *nrows = 0; - *ncols = 0; - } - else - { - *nrows = lammps_get_natoms (ptr); - *ncols = compute->size_peratom_cols; - } - } - else if ( style == 2 ) - { - if ( !compute->local_flag ) - { - *nrows = 0; - *ncols = 0; - } - else - { - *nrows = compute->size_local_rows; - *ncols = compute->size_local_cols; - } - } - else - { - *nrows = 0; - *ncols = 0; - } - + int *tmp; + tmp = (int *) lammps_extract_compute(ptr, id, style, LMP_SIZE_ROWS); + if (tmp) *nrows = *tmp; + tmp = (int *) lammps_extract_compute(ptr, id, style, LMP_SIZE_COLS); + if (tmp) *ncols = *tmp; return; } int lammps_extract_fix_vectorsize (void *ptr, char *id, int style) { - class LAMMPS *lmp = (class LAMMPS *) ptr; - int ifix = lmp->modify->find_fix(id); - if ( ifix < 0 ) return 0; - class Fix *fix = lmp->modify->fix[ifix]; - - if ( style == 0 ) - { - if ( !fix->vector_flag ) - return 0; - else - return fix->size_vector; - } - else if ( style == 1 ) - { - return lammps_get_natoms (ptr); - } - else if ( style == 2 ) - { - if ( !fix->local_flag ) - return 0; - else - return fix->size_local_rows; - } - else - return 0; + int *size; + size = (int *) lammps_extract_fix(ptr, id, style, LMP_SIZE_VECTOR, 0, 0); + if (size) return *size; + return 0; } void lammps_extract_fix_arraysize (void *ptr, char *id, int style, int *nrows, int *ncols) { - class LAMMPS *lmp = (class LAMMPS *) ptr; - int ifix = lmp->modify->find_fix(id); - if ( ifix < 0 ) - { - *nrows = 0; - *ncols = 0; - } - class Fix *fix = lmp->modify->fix[ifix]; - - if ( style == 0 ) - { - if ( !fix->array_flag ) - { - *nrows = 0; - *ncols = 0; - } - else - { - *nrows = fix->size_array_rows; - *ncols = fix->size_array_cols; - } - } - else if ( style == 1 ) - { - if ( !fix->peratom_flag ) - { - *nrows = 0; - *ncols = 0; - } - else - { - *nrows = lammps_get_natoms (ptr); - *ncols = fix->size_peratom_cols; - } - } - else if ( style == 2 ) - { - if ( !fix->local_flag ) - { - *nrows = 0; - *ncols = 0; - } - else - { - *nrows = fix->size_local_rows; - *ncols = fix->size_local_cols; - } - } - else - { - *nrows = 0; - *ncols = 0; - } - + int *tmp; + tmp = (int *) lammps_extract_fix(ptr, id, style, LMP_SIZE_ROWS, 0, 0); + if (tmp) *nrows = *tmp; + tmp = (int *) lammps_extract_fix(ptr, id, style, LMP_SIZE_COLS, 0, 0); + if (tmp) *ncols = *tmp; return; - } /* vim: set ts=3 sts=3 expandtab: */ From 2fb36084625933d9544681becc550d52f9402432 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 22 Jun 2022 07:06:16 -0400 Subject: [PATCH 424/585] update/correct contact info --- examples/COUPLE/fortran_dftb/LAMMPS-wrapper2.cpp | 3 +-- examples/COUPLE/fortran_dftb/LAMMPS-wrapper2.h | 2 +- 2 files changed, 2 insertions(+), 3 deletions(-) diff --git a/examples/COUPLE/fortran_dftb/LAMMPS-wrapper2.cpp b/examples/COUPLE/fortran_dftb/LAMMPS-wrapper2.cpp index 605735a2b7..44d7b5bca4 100644 --- a/examples/COUPLE/fortran_dftb/LAMMPS-wrapper2.cpp +++ b/examples/COUPLE/fortran_dftb/LAMMPS-wrapper2.cpp @@ -12,8 +12,7 @@ ------------------------------------------------------------------------- */ /* ------------------------------------------------------------------------ - Contributing author: Karl D. Hammond - University of Missouri (USA), 2012 + Contributing author: Nir Goldman, LLNL , 2016 ------------------------------------------------------------------------- */ /* This is set of "wrapper" functions to assist LAMMPS.F90, which itself diff --git a/examples/COUPLE/fortran_dftb/LAMMPS-wrapper2.h b/examples/COUPLE/fortran_dftb/LAMMPS-wrapper2.h index ed79015e78..d3705179ed 100644 --- a/examples/COUPLE/fortran_dftb/LAMMPS-wrapper2.h +++ b/examples/COUPLE/fortran_dftb/LAMMPS-wrapper2.h @@ -12,7 +12,7 @@ ------------------------------------------------------------------------- */ /* ------------------------------------------------------------------------ - Contributing author: Nir Goldman, ngoldman@llnl.gov, Oct. 19th, 2016 + Contributing author: Nir Goldman, LLNL , 2016 ------------------------------------------------------------------------- */ /* This is set of "wrapper" functions to assist LAMMPS.F90, which itself From 9b8c19c1a5846db7a04c8d70b6e8f74720390da6 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 22 Jun 2022 10:24:56 -0400 Subject: [PATCH 425/585] correct docs about how to get synchronized timings --- doc/src/Speed_measure.rst | 3 +-- 1 file changed, 1 insertion(+), 2 deletions(-) diff --git a/doc/src/Speed_measure.rst b/doc/src/Speed_measure.rst index 1daf49f4c4..888e8d9790 100644 --- a/doc/src/Speed_measure.rst +++ b/doc/src/Speed_measure.rst @@ -42,5 +42,4 @@ inaccurate relative timing data, because processors have to wait when communication occurs for other processors to catch up. Thus the reported times for "Communication" or "Other" may be higher than they really are, due to load-imbalance. If this is an issue, you can -uncomment the MPI_Barrier() lines in src/timer.cpp, and re-compile -LAMMPS, to obtain synchronized timings. +use the :doc:`timer sync ` command to obtain synchronized timings. From c5999df3039a4921f978993c06ed3df09dabf66c Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 22 Jun 2022 10:32:03 -0400 Subject: [PATCH 426/585] remove dead code and silence compiler warning about it --- src/EXTRA-COMPUTE/compute_stress_cartesian.cpp | 5 +---- 1 file changed, 1 insertion(+), 4 deletions(-) diff --git a/src/EXTRA-COMPUTE/compute_stress_cartesian.cpp b/src/EXTRA-COMPUTE/compute_stress_cartesian.cpp index f873c70bae..2dde2397db 100644 --- a/src/EXTRA-COMPUTE/compute_stress_cartesian.cpp +++ b/src/EXTRA-COMPUTE/compute_stress_cartesian.cpp @@ -266,7 +266,7 @@ void ComputeStressCartesian::compute_array() Pair *pair = force->pair; double **cutsq = force->pair->cutsq; - double xi1, xi2, xj1, xj2; + double xi1, xi2; for (ii = 0; ii < inum; ii++) { i = ilist[ii]; @@ -305,9 +305,6 @@ void ComputeStressCartesian::compute_array() } } } - xj1 = x[j][dir1]; - xj2 = x[j][dir2]; - delx = x[j][0] - xtmp; dely = x[j][1] - ytmp; delz = x[j][2] - ztmp; From 2396c16026c040b95845905797eb524e56e9a655 Mon Sep 17 00:00:00 2001 From: rohskopf Date: Wed, 22 Jun 2022 09:32:41 -0600 Subject: [PATCH 427/585] Update example and docs. --- doc/src/compute_sna_atom.rst | 43 ++- examples/snap/README.md | 10 +- examples/snap/compute_snap_dgrad.py | 24 +- src/ML-SNAP/compute_snap.cpp | 146 ++++---- src/ML-SNAP/compute_snap.h | 6 +- src/ML-SNAP/compute_snapneigh.cpp | 563 ---------------------------- src/ML-SNAP/compute_snapneigh.h | 73 ---- 7 files changed, 139 insertions(+), 726 deletions(-) delete mode 100644 src/ML-SNAP/compute_snapneigh.cpp delete mode 100644 src/ML-SNAP/compute_snapneigh.h diff --git a/doc/src/compute_sna_atom.rst b/doc/src/compute_sna_atom.rst index 54a6df02a2..e3255f201d 100644 --- a/doc/src/compute_sna_atom.rst +++ b/doc/src/compute_sna_atom.rst @@ -33,7 +33,7 @@ Syntax * R_1, R_2,... = list of cutoff radii, one for each type (distance units) * w_1, w_2,... = list of neighbor weights, one for each type * zero or more keyword/value pairs may be appended -* keyword = *rmin0* or *switchflag* or *bzeroflag* or *quadraticflag* or *chem* or *bnormflag* or *wselfallflag* or *bikflag* or *switchinnerflag* or *sinner* or *dinner* +* keyword = *rmin0* or *switchflag* or *bzeroflag* or *quadraticflag* or *chem* or *bnormflag* or *wselfallflag* or *bikflag* or *switchinnerflag* or *sinner* or *dinner* or *dgradflag* .. parsed-literal:: @@ -66,6 +66,9 @@ Syntax *sinnerlist* = *ntypes* values of *Sinner* (distance units) *dinner* values = *dinnerlist* *dinnerlist* = *ntypes* values of *Dinner* (distance units) + *dgradflag* value = *0* or *1* + *0* = bispectrum descriptor gradients are summed over neighbors + *1* = bispectrum descriptor gradients are not summed over neighbors Examples """""""" @@ -340,6 +343,14 @@ When the central atom and the neighbor atom have different types, the values of :math:`S_{inner}` and :math:`D_{inner}` are the arithmetic means of the values for both types. +The keyword *dgradflag* determines whether or not to sum the bispectrum descriptor gradients over neighboring atoms *i'* +as explained with *snad/atom* above. If *dgradflag* is set to 1 then the descriptor gradient rows of the global snap array +are not summed over atoms *i'*. Instead, each row corresponds to a single term :math:`\frac{\partial {B_{i,k} }}{\partial {r}^a_j}` +where :math:`a` is the Cartesian direction for the gradient. This also changes +the number of columns to be equal to the number of bispectrum components, with 3 +additional columns representing the indices :math:`i`, :math:`j`, and :math:`a`, +as explained more in the Output info section below. The option *dgradflag=1* must be used with *bikflag=1*. + .. note:: If you have a bonded system, then the settings of :doc:`special_bonds @@ -435,6 +446,36 @@ components. For the purposes of handling contributions to force, virial, and quadratic combinations, these :math:`N_{elem}^3` sub-blocks are treated as a single block of :math:`K N_{elem}^3` columns. +If the *bik* keyword is set to 1, then the first :math:`N` rows of the snap array +correspond to :math:`B_{i,k}` instead of the sum over atoms :math:`i`. In this case, the entries in the final column for these rows +are set to zero. + +If the *dgradflag* keyword is set to 1, this changes the structure of the snap array completely. +Here the *snad/atom* quantities are replaced with rows corresponding to descriptor +gradient components + +.. math:: + + \frac{\partial {B_{i,k} }}{\partial {r}^a_j} + +where :math:`a` is the Cartesian direction for the gradient. The rows are organized in chunks, where each chunk corresponds to +an atom :math:`j` in the system of :math:`N` atoms. The rows in an atom :math:`j` chunk correspond to neighbors :math:`i` of :math:`j`. +The number of rows in the atom :math:`j` chunk is therefore equal to the number of neighbors :math:`N_{neighs}[j]` within the SNAP +potential cutoff radius of atom :math:`j`, times 3 for each Cartesian direction. +The total number of rows for these descriptor gradients is therefore + +.. math:: + + 3 \sum_j^{N} N_{neighs}[j]. + +For *dgradflag=1*, the number of columns is equal to the number of bispectrum components, +plus 3 additional columns representing the indices :math:`i`, :math:`j`, and :math:`a` which +identify the atoms :math:`i` and :math:`j`, and Cartesian direction :math:`a` for which +a particular gradient :math:`\frac{\partial {B_{i,k} }}{\partial {r}^a_j}` belongs to. The reference energy and forces are also located in different parts of the array. +The last 3 columns of the first :math:`N` rows belong to the reference potential force components. +The first column of the last row, after the first :math:`N + 3 \sum_j^{N} N_{neighs}[j]` rows, +contains the reference potential energy. The virial components are not used with this option. + These values can be accessed by any command that uses per-atom values from a compute as input. See the :doc:`Howto output ` doc page for an overview of LAMMPS output options. To see how this command diff --git a/examples/snap/README.md b/examples/snap/README.md index 7c34fe7021..e1bd54ff37 100644 --- a/examples/snap/README.md +++ b/examples/snap/README.md @@ -1,9 +1 @@ -See `compute_snap_dgrad.py` for a test that compares the dBi/dRj from compute snap (`dbirjflag=1`) to the sum of dBi/dRj from usual compute snap (`dbirjflag=0`). - -The format of the global array from `dbirjflag=1` is as follows. - -The first N rows belong to bispectrum components for each atom, if we use `bikflag=1`. The first `K` columns correspond to each bispectrum coefficient. The final 3 columns contain reference force components for each atom. - -The rows after the first N rows contain dBi/dRj values for all pairs. These values are arranged in row chunks for each atom `j`, where all the rows in a chunk are associated with the neighbors `i` of `j`, as well as the self-terms where `i=j`. So for atom `j`, the number of rows is equal to the number of atoms within the SNAP cutoff, plus 1 for the `i=j` terms, times 3 for each Cartesian component. The total number of dBi/dRj rows is therefore equal to `N*(Nneigh+1)*3`, and `Nneigh` may be different for each atom. To facilitate with determining which row belong to which atom pair `ij`, the last 3 columns contain indices; the 3rd to last column contains global indices of atoms `i` (the neighbors), the 2nd to last column contains global indices of atoms `j`, and the last column contains an index 0,1,2 for the Cartesian component. Like the `bik` rows, the first `K` columns correspond to each bispectrum coefficient. - -Finally, the first column of the last row contains the reference energy. +See `compute_snap_dgrad.py` for a test that compares the dBi/dRj from compute snap (`dgradflag=1`) to the sum of dBi/dRj from usual compute snap (`dgradflag=0`). diff --git a/examples/snap/compute_snap_dgrad.py b/examples/snap/compute_snap_dgrad.py index dc06ae1576..84d0b8113a 100644 --- a/examples/snap/compute_snap_dgrad.py +++ b/examples/snap/compute_snap_dgrad.py @@ -1,8 +1,8 @@ """ compute_snap_dgrad.py Purpose: Demonstrate extraction of descriptor gradient (dB/dR) array from compute snap. - Show that dBi/dRj components summed over neighbors i yields same output as regular compute snap with dbirjflag=0. - This shows that the dBi/dRj components extracted with dbirjflag=1 are correct. + Show that dBi/dRj components summed over neighbors i yields same output as regular compute snap with dgradflag=0. + This shows that the dBi/dRj components extracted with dgradflag=1 are correct. Serial syntax: python compute_snap_dgrad.py Parallel syntax: @@ -24,7 +24,7 @@ from lammps import lammps, LMP_TYPE_ARRAY, LMP_STYLE_GLOBAL cmds = ["-screen", "none", "-log", "none"] lmp = lammps(cmdargs=cmds) -def run_lammps(dbirjflag): +def run_lammps(dgradflag): lmp.command("clear") lmp.command("units metal") lmp.command("boundary p p p") @@ -36,7 +36,7 @@ def run_lammps(dbirjflag): lmp.command("mass * 180.88") lmp.command("displace_atoms all random 0.01 0.01 0.01 123456") # Pair style - snap_options=f'{rcutfac} {rfac0} {twojmax} {radelem1} {radelem2} {wj1} {wj2} rmin0 {rmin0} quadraticflag {quadratic} bzeroflag {bzero} switchflag {switch} bikflag {bikflag} dbirjflag {dbirjflag}' + snap_options=f'{rcutfac} {rfac0} {twojmax} {radelem1} {radelem2} {wj1} {wj2} rmin0 {rmin0} quadraticflag {quadratic} bzeroflag {bzero} switchflag {switch} bikflag {bikflag} dgradflag {dgradflag}' lmp.command(f"pair_style zero {rcutfac}") lmp.command(f"pair_coeff * *") lmp.command(f"pair_style zbl {zblcutinner} {zblcutouter}") @@ -70,7 +70,7 @@ quadratic=0 bzero=0 switch=0 bikflag=1 -dbirjflag=1 +dgradflag=1 # Declare reference potential variables zblcutinner=4.0 @@ -84,7 +84,8 @@ else: nd = int(m*(m+1)*(m+2)/3) print(f"Number of descriptors based on twojmax : {nd}") -# Run lammps with dbirjflag on +# Run lammps with dgradflag on +print("Running with dgradflag on") run_lammps(1) # Get global snap array @@ -93,12 +94,12 @@ lmp_snap = lmp.numpy.extract_compute("snap",0, 2) # Extract dBj/dRi (includes dBi/dRi) natoms = lmp.get_natoms() fref1 = lmp_snap[0:natoms,-3:].flatten() -eref1 = lmp_snap[-6,0] -dbdr_length = np.shape(lmp_snap)[0]-(natoms)-6 # Length of neighborlist pruned dbdr array +eref1 = lmp_snap[-1,0] #lmp_snap[-6,0] +dbdr_length = np.shape(lmp_snap)[0]-(natoms) - 1 #-6 # Length of neighborlist pruned dbdr array dBdR = lmp_snap[natoms:(natoms+dbdr_length),:] force_indices = lmp_snap[natoms:(natoms+dbdr_length),-3:].astype(np.int32) -# Sum over neighbors j for each atom i, like dbirjflag=0 does. +# Sum over neighbors j for each atom i, like dgradflag=0 does. array1 = np.zeros((3*natoms,nd)) a = 0 for k in range(0,nd): @@ -111,7 +112,8 @@ for k in range(0,nd): if (a>2): a=0 -# Run lammps with dbirjflag off +# Run lammps with dgradflag off +print("Running with dgradflag off") run_lammps(0) # Get global snap array @@ -121,7 +123,7 @@ fref2 = lmp_snap[natoms:(natoms+3*natoms),-1] eref2 = lmp_snap[0,-1] array2 = lmp_snap[natoms:natoms+(3*natoms), nd:-1] -# Sum the arrays obtained from dbirjflag on and off. +# Sum the arrays obtained from dgradflag on and off. summ = array1 + array2 #np.savetxt("sum.dat", summ) diff --git a/src/ML-SNAP/compute_snap.cpp b/src/ML-SNAP/compute_snap.cpp index d1b0980dfb..88360a5005 100644 --- a/src/ML-SNAP/compute_snap.cpp +++ b/src/ML-SNAP/compute_snap.cpp @@ -56,7 +56,7 @@ ComputeSnap::ComputeSnap(LAMMPS *lmp, int narg, char **arg) : bzeroflag = 1; quadraticflag = 0; bikflag = 0; - dbirjflag = 0; + dgradflag = 0; chemflag = 0; bnormflag = 0; wselfallflag = 0; @@ -148,10 +148,10 @@ ComputeSnap::ComputeSnap(LAMMPS *lmp, int narg, char **arg) : error->all(FLERR,"Illegal compute snap command"); bikflag = atoi(arg[iarg+1]); iarg += 2; - } else if (strcmp(arg[iarg],"dbirjflag") == 0) { + } else if (strcmp(arg[iarg],"dgradflag") == 0) { if (iarg+2 > narg) error->all(FLERR,"Illegal compute snap command"); - dbirjflag = atoi(arg[iarg+1]); + dgradflag = atoi(arg[iarg+1]); iarg += 2; } else if (strcmp(arg[iarg],"switchinnerflag") == 0) { if (iarg+2 > narg) @@ -185,6 +185,9 @@ ComputeSnap::ComputeSnap(LAMMPS *lmp, int narg, char **arg) : if (!switchinnerflag && (sinnerflag || dinnerflag)) error->all(FLERR,"Illegal compute snap command: switchinnerflag = 0, unexpected sinner/dinner keyword"); + if (dgradflag && !bikflag) + error->all(FLERR,"Illegal compute snap command: dgradflag=1 requires bikflag=1"); + snaptr = new SNA(lmp, rfac0, twojmax, rmin0, switchflag, bzeroflag, chemflag, bnormflag, wselfallflag, @@ -200,9 +203,9 @@ ComputeSnap::ComputeSnap(LAMMPS *lmp, int narg, char **arg) : natoms = atom->natoms; bik_rows = 1; if (bikflag) bik_rows = natoms; - dbirj_rows = ndims_force*natoms; - size_array_rows = bik_rows+dbirj_rows+ndims_virial; - if (dbirjflag) size_array_cols = nperdim+3; // plus 3 for tag[i], tag[j], and cartesian index + dgrad_rows = ndims_force*natoms; + size_array_rows = bik_rows+dgrad_rows+ndims_virial; + if (dgradflag) size_array_cols = nperdim+3; // plus 3 for tag[i], tag[j], and cartesian index else size_array_cols = nperdim*atom->ntypes+1; lastcol = size_array_cols-1; @@ -230,8 +233,8 @@ ComputeSnap::~ComputeSnap() memory->destroy(sinnerelem); memory->destroy(dinnerelem); } - if (dbirjflag){ - memory->destroy(dbirj); + if (dgradflag){ + memory->destroy(dgrad); memory->destroy(nneighs); memory->destroy(neighsum); memory->destroy(icounter); @@ -260,10 +263,19 @@ void ComputeSnap::init() // allocate memory for global array - memory->create(snap,size_array_rows,size_array_cols, - "snap:snap"); - memory->create(snapall,size_array_rows,size_array_cols, - "snap:snapall"); + if (dgradflag){ + // Initially allocate natoms^2 rows, will prune with neighborlist later + memory->create(snap,natoms*natoms,ncoeff+3, + "snap:snap"); + memory->create(snapall,natoms*natoms,ncoeff+3, + "snap:snapall"); + } + else{ + memory->create(snap,size_array_rows,size_array_cols, + "snap:snap"); + memory->create(snapall,size_array_rows,size_array_cols, + "snap:snapall"); + } array = snapall; // find compute for reference energy @@ -299,8 +311,8 @@ void ComputeSnap::init_list(int /*id*/, NeighList *ptr) void ComputeSnap::compute_array() { - if (dbirjflag){ - get_dbirj_length(); + if (dgradflag){ + get_dgrad_length(); } int ntotal = atom->nlocal + atom->nghost; @@ -345,7 +357,7 @@ void ComputeSnap::compute_array() const int* const mask = atom->mask; int ninside; int numneigh_sum = 0; - int dbirj_row_indx; + int dgrad_row_indx; for (int ii = 0; ii < inum; ii++) { int irow = 0; if (bikflag) irow = atom->tag[ilist[ii] & NEIGHMASK]-1; @@ -416,8 +428,8 @@ void ComputeSnap::compute_array() for (int jj = 0; jj < ninside; jj++) { const int j = snaptr->inside[jj]; - if (dbirjflag){ - dbirj_row_indx = 3*neighsum[atom->tag[j]-1] + 3*icounter[atom->tag[j]-1] ; + if (dgradflag){ + dgrad_row_indx = 3*neighsum[atom->tag[j]-1] + 3*icounter[atom->tag[j]-1] ; icounter[atom->tag[j]-1] += 1; } @@ -440,20 +452,20 @@ void ComputeSnap::compute_array() snadj[icoeff+zoffset] -= snaptr->dblist[icoeff][2]; - if (dbirjflag){ - dbirj[dbirj_row_indx+0][icoeff] = snaptr->dblist[icoeff][0]; - dbirj[dbirj_row_indx+1][icoeff] = snaptr->dblist[icoeff][1]; - dbirj[dbirj_row_indx+2][icoeff] = snaptr->dblist[icoeff][2]; + if (dgradflag){ + dgrad[dgrad_row_indx+0][icoeff] = snaptr->dblist[icoeff][0]; + dgrad[dgrad_row_indx+1][icoeff] = snaptr->dblist[icoeff][1]; + dgrad[dgrad_row_indx+2][icoeff] = snaptr->dblist[icoeff][2]; if (icoeff==(ncoeff-1)){ - dbirj[dbirj_row_indx+0][ncoeff] = atom->tag[i]-1; - dbirj[dbirj_row_indx+0][ncoeff+1] = atom->tag[j]-1; - dbirj[dbirj_row_indx+0][ncoeff+2] = 0; - dbirj[dbirj_row_indx+1][ncoeff] = atom->tag[i]-1; - dbirj[dbirj_row_indx+1][ncoeff+1] = atom->tag[j]-1; - dbirj[dbirj_row_indx+1][ncoeff+2] = 1; - dbirj[dbirj_row_indx+2][ncoeff] = atom->tag[i]-1; - dbirj[dbirj_row_indx+2][ncoeff+1] = atom->tag[j]-1; - dbirj[dbirj_row_indx+2][ncoeff+2] = 2; + dgrad[dgrad_row_indx+0][ncoeff] = atom->tag[i]-1; + dgrad[dgrad_row_indx+0][ncoeff+1] = atom->tag[j]-1; + dgrad[dgrad_row_indx+0][ncoeff+2] = 0; + dgrad[dgrad_row_indx+1][ncoeff] = atom->tag[i]-1; + dgrad[dgrad_row_indx+1][ncoeff+1] = atom->tag[j]-1; + dgrad[dgrad_row_indx+1][ncoeff+2] = 1; + dgrad[dgrad_row_indx+2][ncoeff] = atom->tag[i]-1; + dgrad[dgrad_row_indx+2][ncoeff+1] = atom->tag[j]-1; + dgrad[dgrad_row_indx+2][ncoeff+2] = 2; } // Accumulate dBi/dRi = sum (-dBi/dRj) for neighbors j of if i dbiri[3*(atom->tag[i]-1)+0][icoeff] -= snaptr->dblist[icoeff][0]; @@ -530,7 +542,7 @@ void ComputeSnap::compute_array() // linear contributions int k; - if (dbirjflag) k = 0; + if (dgradflag) k = 0; else k = typeoffset_global; for (int icoeff = 0; icoeff < ncoeff; icoeff++){ snap[irow][k++] += snaptr->blist[icoeff]; @@ -555,7 +567,7 @@ void ComputeSnap::compute_array() // Accumulate contributions to global array - if (dbirjflag){ + if (dgradflag){ int dbiri_indx; int irow; @@ -568,34 +580,34 @@ void ComputeSnap::compute_array() for (int jj=0; jjtag[i]-1] + 3*jj; + int dgrad_row_indx = 3*neighsum[atom->tag[i]-1] + 3*jj; int snap_row_indx = 3*neighsum[atom->tag[i]-1] + 3*(atom->tag[i]-1) + 3*jj; irow = snap_row_indx + bik_rows; // x-coordinate - snap[irow][icoeff+typeoffset_global] += dbirj[dbirj_row_indx+0][icoeff]; + snap[irow][icoeff+typeoffset_global] += dgrad[dgrad_row_indx+0][icoeff]; if (icoeff==(ncoeff-1)){ - snap[irow][ncoeff] += dbirj[dbirj_row_indx+0][ncoeff]; - snap[irow][ncoeff+1] += dbirj[dbirj_row_indx+0][ncoeff+1]; - snap[irow][ncoeff+2] += dbirj[dbirj_row_indx+0][ncoeff+2]; + snap[irow][ncoeff] += dgrad[dgrad_row_indx+0][ncoeff]; + snap[irow][ncoeff+1] += dgrad[dgrad_row_indx+0][ncoeff+1]; + snap[irow][ncoeff+2] += dgrad[dgrad_row_indx+0][ncoeff+2]; } irow++; // y-coordinate - snap[irow][icoeff+typeoffset_global] += dbirj[dbirj_row_indx+1][icoeff]; + snap[irow][icoeff+typeoffset_global] += dgrad[dgrad_row_indx+1][icoeff]; if (icoeff==(ncoeff-1)){ - snap[irow][ncoeff] += dbirj[dbirj_row_indx+1][ncoeff]; - snap[irow][ncoeff+1] += dbirj[dbirj_row_indx+1][ncoeff+1]; - snap[irow][ncoeff+2] += dbirj[dbirj_row_indx+1][ncoeff+2]; + snap[irow][ncoeff] += dgrad[dgrad_row_indx+1][ncoeff]; + snap[irow][ncoeff+1] += dgrad[dgrad_row_indx+1][ncoeff+1]; + snap[irow][ncoeff+2] += dgrad[dgrad_row_indx+1][ncoeff+2]; } irow++; // z-coordinate - snap[irow][icoeff+typeoffset_global] += dbirj[dbirj_row_indx+2][icoeff]; + snap[irow][icoeff+typeoffset_global] += dgrad[dgrad_row_indx+2][icoeff]; if (icoeff==(ncoeff-1)){ - snap[irow][ncoeff] += dbirj[dbirj_row_indx+2][ncoeff]; - snap[irow][ncoeff+1] += dbirj[dbirj_row_indx+2][ncoeff+1]; - snap[irow][ncoeff+2] += dbirj[dbirj_row_indx+2][ncoeff+2]; + snap[irow][ncoeff] += dgrad[dgrad_row_indx+2][ncoeff]; + snap[irow][ncoeff+1] += dgrad[dgrad_row_indx+2][ncoeff+1]; + snap[irow][ncoeff+2] += dgrad[dgrad_row_indx+2][ncoeff+2]; } dbiri_indx = dbiri_indx+3; } @@ -659,8 +671,8 @@ void ComputeSnap::compute_array() // accumulate forces to global array - if (dbirjflag){ - // for dbirjflag=1, put forces at last 3 columns of bik rows + if (dgradflag){ + // for dgradflag=1, put forces at last 3 columns of bik rows for (int i=0; inlocal; i++){ int iglobal = atom->tag[i]; snap[iglobal-1][ncoeff+0] = atom->f[i][0]; @@ -681,8 +693,8 @@ void ComputeSnap::compute_array() // accumulate bispectrum virial contributions to global array - if (dbirjflag){ - // no virial terms for dbirj yet + if (dgradflag){ + // no virial terms for dgrad yet } else{ dbdotr_compute(); @@ -691,10 +703,10 @@ void ComputeSnap::compute_array() // sum up over all processes MPI_Allreduce(&snap[0][0],&snapall[0][0],size_array_rows*size_array_cols,MPI_DOUBLE,MPI_SUM,world); // assign energy to last column - if (dbirjflag){ - // Assign reference energy right after the dbirj rows, first column. + if (dgradflag){ + // Assign reference energy right after the dgrad rows, first column. // Add 3N for the dBi/dRi rows. - int irow = bik_rows + dbirj_rows + 3*natoms; + int irow = bik_rows + dgrad_rows + 3*natoms; double reference_energy = c_pe->compute_scalar(); snapall[irow][0] = reference_energy; } @@ -709,10 +721,11 @@ void ComputeSnap::compute_array() // switch to Voigt notation c_virial->compute_vector(); - if (dbirjflag){ - // no virial terms for dbirj yet + if (dgradflag){ + // no virial terms for dgrad yet } else{ + c_virial->compute_vector(); int irow = 3*natoms+bik_rows; snapall[irow++][lastcol] = c_virial->vector[0]; snapall[irow++][lastcol] = c_virial->vector[1]; @@ -760,10 +773,10 @@ void ComputeSnap::dbdotr_compute() } /* ---------------------------------------------------------------------- - compute dbirj length + compute dgrad length ------------------------------------------------------------------------- */ -void ComputeSnap::get_dbirj_length() +void ComputeSnap::get_dgrad_length() { int rank = universe->me; // for MPI debugging @@ -772,7 +785,7 @@ void ComputeSnap::get_dbirj_length() memory->destroy(snapall); // invoke full neighbor list neighbor->build_one(list); - dbirj_rows = 0; + dgrad_rows = 0; const int inum = list->inum; const int* const ilist = list->ilist; const int* const numneigh = list->numneigh; @@ -791,7 +804,7 @@ void ComputeSnap::get_dbirj_length() memory->create(icounter, natoms, "snap:icounter"); memory->create(dbiri, 3*natoms,ncoeff+3, "snap:dbiri"); if (atom->nlocal != natoms){ - error->all(FLERR,"Compute snap dbirjflag=1 does not support parallelism."); + error->all(FLERR,"Compute snap dgradflag=1 does not support parallelism."); } for (int ii=0; ii<3*natoms; ii++){ for (int icoeff=0; icoeff1e-20) { - dbirj_rows += 1; //jnum + 1; + dgrad_rows += 1; //jnum + 1; jnum_cutoff += 1; nneighs[i]+=1; } @@ -830,7 +843,7 @@ void ComputeSnap::get_dbirj_length() } } - dbirj_rows *= ndims_force; + dgrad_rows *= ndims_force; // Loop over all atoms again to calculate neighsum. for (int ii = 0; ii < inum; ii++) { @@ -850,14 +863,15 @@ void ComputeSnap::get_dbirj_length() } } - memory->create(dbirj, dbirj_rows, ncoeff+3, "snap:dbirj"); - for (int i=0; icreate(dgrad, dgrad_rows, ncoeff+3, "snap:dgrad"); + for (int i=0; inlocal; // Add 3*N for dBi/dRi + // Set size array rows which now depends on dgrad_rows. + //size_array_rows = bik_rows+dgrad_rows+ndims_virial+3*atom->nlocal; // Add 3*N for dBi/dRi + size_array_rows = bik_rows + dgrad_rows + 3*atom->nlocal + 1; // Add 3*N for dBi/dRi. and add 1 for reference energy memory->create(snap,size_array_rows,size_array_cols, "snap:snap"); memory->create(snapall,size_array_rows,size_array_cols, "snap:snapall"); @@ -871,7 +885,7 @@ void ComputeSnap::get_dbirj_length() double ComputeSnap::compute_scalar() { - if (dbirjflag) get_dbirj_length(); + if (dgradflag) get_dgrad_length(); return size_array_rows; } diff --git a/src/ML-SNAP/compute_snap.h b/src/ML-SNAP/compute_snap.h index 3b03512efc..447f6d286d 100644 --- a/src/ML-SNAP/compute_snap.h +++ b/src/ML-SNAP/compute_snap.h @@ -56,8 +56,8 @@ class ComputeSnap : public Compute { int quadraticflag; //int bikflag; //int bik_rows; - int bikflag, bik_rows, dbirjflag, dbirj_rows; - double **dbirj; + int bikflag, bik_rows, dgradflag, dgrad_rows; + double **dgrad; double **dbiri; // dBi/dRi = sum(-dBi/dRj) over neighbors j int *nneighs; // number of neighs inside the snap cutoff. int *neighsum; @@ -67,7 +67,7 @@ class ComputeSnap : public Compute { Compute *c_virial; void dbdotr_compute(); - void get_dbirj_length(); + void get_dgrad_length(); }; } // namespace LAMMPS_NS diff --git a/src/ML-SNAP/compute_snapneigh.cpp b/src/ML-SNAP/compute_snapneigh.cpp deleted file mode 100644 index eef18a93f4..0000000000 --- a/src/ML-SNAP/compute_snapneigh.cpp +++ /dev/null @@ -1,563 +0,0 @@ -// clang-format off -/* ---------------------------------------------------------------------- - LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator - https://www.lammps.org/, Sandia National Laboratories - Steve Plimpton, sjplimp@sandia.gov - - Copyright (2003) Sandia Corporation. Under the terms of Contract - DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains - certain rights in this software. This software is distributed under - the GNU General Public License. - - See the README file in the top-level LAMMPS directory. -------------------------------------------------------------------------- */ - -#include "compute_snapneigh.h" - -#include "sna.h" -#include "atom.h" -#include "update.h" -#include "modify.h" -#include "neighbor.h" -#include "neigh_list.h" -#include "force.h" -#include "pair.h" -#include "comm.h" -#include "memory.h" -#include "error.h" - -#include - -using namespace LAMMPS_NS; - -enum{SCALAR,VECTOR,ARRAY}; - -ComputeSnapneigh::ComputeSnapneigh(LAMMPS *lmp, int narg, char **arg) : - Compute(lmp, narg, arg), cutsq(nullptr), list(nullptr), radelem(nullptr), wjelem(nullptr), - sinnerelem(nullptr), dinnerelem(nullptr) -{ - - array_flag = 1; - //vector_flag = 1; - extarray = 0; - - double rfac0, rmin0; - int twojmax, switchflag, bzeroflag, bnormflag, wselfallflag; - - int ntypes = atom->ntypes; - int nargmin = 6+2*ntypes; - - if (narg < nargmin) error->all(FLERR,"Illegal compute snap command"); - - // default values - - rmin0 = 0.0; - switchflag = 1; - bzeroflag = 1; - quadraticflag = 0; - bikflag = 0; - dbirjflag = 0; - chemflag = 0; - bnormflag = 0; - wselfallflag = 0; - switchinnerflag = 0; - nelements = 1; - - // process required arguments - - memory->create(radelem,ntypes+1,"snapneigh:radelem"); // offset by 1 to match up with types - memory->create(wjelem,ntypes+1,"snapneigh:wjelem"); - rcutfac = atof(arg[3]); - rfac0 = atof(arg[4]); - twojmax = atoi(arg[5]); - for (int i = 0; i < ntypes; i++) - radelem[i+1] = atof(arg[6+i]); - for (int i = 0; i < ntypes; i++) - wjelem[i+1] = atof(arg[6+ntypes+i]); - - // construct cutsq - - double cut; - cutmax = 0.0; - memory->create(cutsq,ntypes+1,ntypes+1,"snapneigh:cutsq"); - for (int i = 1; i <= ntypes; i++) { - cut = 2.0*radelem[i]*rcutfac; - //printf("cut: %f\n", cut); - if (cut > cutmax) cutmax = cut; - cutsq[i][i] = cut*cut; - for (int j = i+1; j <= ntypes; j++) { - cut = (radelem[i]+radelem[j])*rcutfac; - cutsq[i][j] = cutsq[j][i] = cut*cut; - } - } - - // set local input checks - - int sinnerflag = 0; - int dinnerflag = 0; - - // process optional args - - int iarg = nargmin; - - while (iarg < narg) { - if (strcmp(arg[iarg],"rmin0") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute snap command"); - rmin0 = atof(arg[iarg+1]); - iarg += 2; - } else if (strcmp(arg[iarg],"bzeroflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute snap command"); - bzeroflag = atoi(arg[iarg+1]); - iarg += 2; - } else if (strcmp(arg[iarg],"switchflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute snap command"); - switchflag = atoi(arg[iarg+1]); - iarg += 2; - } else if (strcmp(arg[iarg],"quadraticflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute snap command"); - quadraticflag = atoi(arg[iarg+1]); - iarg += 2; - } else if (strcmp(arg[iarg],"chem") == 0) { - if (iarg+2+ntypes > narg) - error->all(FLERR,"Illegal compute snap command"); - chemflag = 1; - memory->create(map,ntypes+1,"compute_snapneigh:map"); - nelements = utils::inumeric(FLERR,arg[iarg+1],false,lmp); - for (int i = 0; i < ntypes; i++) { - int jelem = utils::inumeric(FLERR,arg[iarg+2+i],false,lmp); - if (jelem < 0 || jelem >= nelements) - error->all(FLERR,"Illegal compute snap command"); - map[i+1] = jelem; - } - iarg += 2+ntypes; - } else if (strcmp(arg[iarg],"bnormflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute snap command"); - bnormflag = atoi(arg[iarg+1]); - iarg += 2; - } else if (strcmp(arg[iarg],"wselfallflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute snap command"); - wselfallflag = atoi(arg[iarg+1]); - iarg += 2; - } else if (strcmp(arg[iarg],"bikflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute snap command"); - bikflag = atoi(arg[iarg+1]); - iarg += 2; - } else if (strcmp(arg[iarg],"dbirjflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute snap command"); - dbirjflag = atoi(arg[iarg+1]); - iarg += 2; - } else if (strcmp(arg[iarg],"switchinnerflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute snap command"); - switchinnerflag = atoi(arg[iarg+1]); - iarg += 2; - } else if (strcmp(arg[iarg],"sinner") == 0) { - iarg++; - if (iarg+ntypes > narg) - error->all(FLERR,"Illegal compute snap command"); - memory->create(sinnerelem,ntypes+1,"snapneigh:sinnerelem"); - for (int i = 0; i < ntypes; i++) - sinnerelem[i+1] = utils::numeric(FLERR,arg[iarg+i],false,lmp); - sinnerflag = 1; - iarg += ntypes; - } else if (strcmp(arg[iarg],"dinner") == 0) { - iarg++; - if (iarg+ntypes > narg) - error->all(FLERR,"Illegal compute snap command"); - memory->create(dinnerelem,ntypes+1,"snapneigh:dinnerelem"); - for (int i = 0; i < ntypes; i++) - dinnerelem[i+1] = utils::numeric(FLERR,arg[iarg+i],false,lmp); - dinnerflag = 1; - iarg += ntypes; - } else error->all(FLERR,"Illegal compute snap command"); - } - - if (switchinnerflag && !(sinnerflag && dinnerflag)) - error->all(FLERR,"Illegal compute snap command: switchinnerflag = 1, missing sinner/dinner keyword"); - - if (!switchinnerflag && (sinnerflag || dinnerflag)) - error->all(FLERR,"Illegal compute snap command: switchinnerflag = 0, unexpected sinner/dinner keyword"); - - /* - snaptr = new SNA(lmp, rfac0, twojmax, - rmin0, switchflag, bzeroflag, - chemflag, bnormflag, wselfallflag, - nelements, switchinnerflag); - */ - - //ncoeff = snaptr->ncoeff; - nperdim = ncoeff; - if (quadraticflag) nperdim += (ncoeff*(ncoeff+1))/2; - ndims_force = 3; - ndims_virial = 6; - yoffset = nperdim; - zoffset = 2*nperdim; - natoms = atom->natoms; - bik_rows = 1; - if (bikflag) bik_rows = natoms; - //size_array_rows = bik_rows+ndims_force*natoms+ndims_virial; - dbirj_rows = ndims_force*natoms; - size_array_rows = bik_rows+dbirj_rows+ndims_virial; - size_array_cols = nperdim*atom->ntypes+1; - lastcol = size_array_cols-1; - - ndims_peratom = ndims_force; - size_peratom = ndims_peratom*nperdim*atom->ntypes; - - nmax = 0; - -} - -/* ---------------------------------------------------------------------- */ - -ComputeSnapneigh::~ComputeSnapneigh() -{ - - memory->destroy(neighs); - memory->destroy(radelem); - memory->destroy(wjelem); - memory->destroy(cutsq); - //delete snaptr; - - if (chemflag) memory->destroy(map); - - if (switchinnerflag) { - memory->destroy(sinnerelem); - memory->destroy(dinnerelem); - } - - if (dbirjflag){ - //printf("dbirj_rows: %d\n", dbirj_rows); - //memory->destroy(dbirj); - memory->destroy(nneighs); - memory->destroy(neighsum); - memory->destroy(icounter); - //memory->destroy(dbiri); - } -} - -/* ---------------------------------------------------------------------- */ - -void ComputeSnapneigh::init() -{ - if (force->pair == nullptr) - error->all(FLERR,"Compute snap requires a pair style be defined"); - - if (cutmax > force->pair->cutforce){ - //printf("----- cutmax cutforce: %f %f\n", cutmax, force->pair->cutforce); - error->all(FLERR,"Compute snap cutoff is longer than pairwise cutoff"); - } - - // need an occasional full neighbor list - - neighbor->add_request(this, NeighConst::REQ_FULL | NeighConst::REQ_OCCASIONAL); - -} - - -/* ---------------------------------------------------------------------- */ - -void ComputeSnapneigh::init_list(int /*id*/, NeighList *ptr) -{ - list = ptr; -} - -/* ---------------------------------------------------------------------- */ - -void ComputeSnapneigh::compute_array() -{ - - if (dbirjflag){ - //printf("----- dbirjflag true.\n"); - get_dbirj_length(); - //printf("----- got dbirj_length\n"); - } - - //printf("----- cutmax cutforce: %f %f\n", cutmax, force->pair->cutforce); - //else{ - int ntotal = atom->nlocal + atom->nghost; - - invoked_array = update->ntimestep; - - // invoke full neighbor list (will copy or build if necessary) - neighbor->build_one(list); - - const int inum = list->inum; - const int* const ilist = list->ilist; - const int* const numneigh = list->numneigh; - int** const firstneigh = list->firstneigh; - int * const type = atom->type; - - // compute sna derivatives for each atom in group - // use full neighbor list to count atoms less than cutoff - - double** const x = atom->x; - const int* const mask = atom->mask; - //printf("----- inum: %d\n", inum); - //printf("----- NEIGHMASK: %d\n", NEIGHMASK); - int ninside; - int numneigh_sum = 0; - int dbirj_row_indx; - int dbiri_indx=0; - for (int ii = 0; ii < inum; ii++) { - int irow = 0; - if (bikflag) irow = atom->tag[ilist[ii] & NEIGHMASK]-1; - //printf("----- i, itag: %d %d\n", ilist[ii] & NEIGHMASK, atom->tag[ilist[ii]]); - const int i = ilist[ii]; - //printf("----- ii, i: %d %d\n", ii, i); - //printf("----- mask[i] groupbit: %d %d\n", mask[i], groupbit); - if (mask[i] & groupbit) { - - const double xtmp = x[i][0]; - const double ytmp = x[i][1]; - const double ztmp = x[i][2]; - const int itype = type[i]; - int ielem = 0; - if (chemflag) - ielem = map[itype]; - const double radi = radelem[itype]; - const int* const jlist = firstneigh[i]; - const int jnum = numneigh[i]; - const int typeoffset_local = ndims_peratom*nperdim*(itype-1); - const int typeoffset_global = nperdim*(itype-1); - - // insure rij, inside, and typej are of size jnum - - //snaptr->grow_rij(jnum); - - // rij[][3] = displacements between atom I and those neighbors - // inside = indices of neighbors of I within cutoff - // typej = types of neighbors of I within cutoff - // note Rij sign convention => dU/dRij = dU/dRj = -dU/dRi - - /* - This loop assigns quantities in snaptr. - snaptr is a SNA class instance, see sna.h - - */ - //int ninside = 0; - ninside=0; - for (int jj = 0; jj < jnum; jj++) { - int j = jlist[jj]; - j &= NEIGHMASK; - - const double delx = x[j][0] - xtmp; - const double dely = x[j][1] - ytmp; - const double delz = x[j][2] - ztmp; - const double rsq = delx*delx + dely*dely + delz*delz; - int jtype = type[j]; - int jelem = 0; - if (chemflag) - jelem = map[jtype]; - if (rsq < cutsq[itype][jtype]&&rsq>1e-20) { - if (dbirjflag){ - //dbirj_row_indx = 3*neighsum[atom->tag[j]-1] + 3*icounter[atom->tag[j]-1] ; // THIS IS WRONG, SEE NEXT VAR. - //dbirj_row_indx = 3*neighsum[atom->tag[i]-1] + 3*(atom->tag[i]-1) + 3*icounter[atom->tag[j]-1]; // 3*tagi is to leave space for dBi/dRi - dbirj_row_indx = 3*neighsum[atom->tag[j]-1] + 3*icounter[atom->tag[j]-1] + 3*(atom->tag[j]-1); // THIS IS WRONG, SEE NEXT VAR. - //printf("--- %d %d %d %d\n", dbirj_row_indx, 3*neighsum[atom->tag[i]-1], 3*(atom->tag[i]-1), jj); - //printf("jtag, icounter, dbirj_row_indx: %d, %d, %d %d %d\n", atom->tag[j], icounter[atom->tag[j]-1], dbirj_row_indx+0, dbirj_row_indx+1, dbirj_row_indx+2); - icounter[atom->tag[j]-1] += 1; - - neighs[dbirj_row_indx+0][0] = atom->tag[i]; - neighs[dbirj_row_indx+1][0] = atom->tag[i]; - neighs[dbirj_row_indx+2][0] = atom->tag[i]; - - neighs[dbirj_row_indx+0][1] = atom->tag[j]; - neighs[dbirj_row_indx+1][1] = atom->tag[j]; - neighs[dbirj_row_indx+2][1] = atom->tag[j]; - - neighs[dbirj_row_indx+0][2] = 0; - neighs[dbirj_row_indx+1][2] = 1; - neighs[dbirj_row_indx+2][2] = 2; - - dbiri_indx = dbiri_indx+3; - } - } - } - - //printf("--- dbiri_indx: %d\n", dbiri_indx); - // Put dBi/dRi in - - neighs[dbiri_indx+0][0] = atom->tag[i]; - neighs[dbiri_indx+1][0] = atom->tag[i]; - neighs[dbiri_indx+2][0] = atom->tag[i]; - - neighs[dbiri_indx+0][1] = atom->tag[i]; - neighs[dbiri_indx+1][1] = atom->tag[i]; - neighs[dbiri_indx+2][1] = atom->tag[i]; - - neighs[dbiri_indx+0][2] = 0; - neighs[dbiri_indx+1][2] = 1; - neighs[dbiri_indx+2][2] = 2; - - dbiri_indx = dbiri_indx+3; - } - - numneigh_sum += ninside; - } // for (int ii = 0; ii < inum; ii++) - - - // Check icounter. - /* - for (int ii = 0; ii < inum; ii++) { - const int i = ilist[ii]; - if (mask[i] & groupbit) { - printf("icounter[i]: %d\n", icounter[i]); - } - } - */ - - - // sum up over all processes - // I'll need to do something like this... - /* - MPI_Allreduce(&snap[0][0],&snapall[0][0],size_array_rows*size_array_cols,MPI_DOUBLE,MPI_SUM,world); - // assign energy to last column - for (int i = 0; i < bik_rows; i++) snapall[i][lastcol] = 0; - int irow = 0; - double reference_energy = c_pe->compute_scalar(); - snapall[irow][lastcol] = reference_energy; - */ - - /* - for (int i=0; ibuild_one(list); - dbirj_rows = 0; - const int inum = list->inum; - const int* const ilist = list->ilist; - const int* const numneigh = list->numneigh; - int** const firstneigh = list->firstneigh; - int * const type = atom->type; - const int* const mask = atom->mask; - double** const x = atom->x; - //printf("----- inum: %d\n", inum); - memory->create(neighsum, atom->nlocal, "snapneigh:neighsum"); - memory->create(nneighs, atom->nlocal, "snapneigh:nneighs"); - memory->create(icounter, atom->nlocal, "snapneigh:icounter"); - //memory->create(dbiri, 3*inum,ncoeff, "snapneigh:dbiri"); - /* - for (int ii=0; ii1e-20) { - dbirj_rows += 1; //jnum + 1; - jnum_cutoff += 1; - nneighs[i]+=1; - } - } - //printf("----- jnum_cutoff: %d\n", jnum_cutoff); - } - } - - dbirj_rows *= ndims_force; - - // Loop over all atoms again to calculate neighsum. - for (int ii = 0; ii < inum; ii++) { - const int i = ilist[ii]; - if (mask[i] & groupbit) { - //printf("nneighs[i]: %d\n", nneighs[i]); - //neighsum[i] = 0; - //printf("i nneighs[i]: %d %d\n", i, nneighs[i]); - if (i==0){ - neighsum[i]=0; - } - else{ - for (int jj=0; jj < ii; jj++){ - const int j = ilist[jj]; - if (mask[j] & groupbit) { - //printf(" j nneighs[j-1]: %d %d\n", j, nneighs[j]); - neighsum[i] += nneighs[j]; - } - } - //neighsum[i] += 1; // Add 1 for the self term dBi/dRi - } - } - //printf("%d\n", neighsum[i]); - } - - size_array_rows = dbirj_rows+(3*atom->nlocal); - size_array_cols = 3; - //memory->create(dbirj, dbirj_rows, ncoeff, "snapneigh:dbirj"); - memory->create(neighs, size_array_rows, size_array_cols, "snapneigh:neighs"); - - //vector = neighs; - array = neighs; - // Set size array rows which now depends on dbirj_rows. - //size_array_rows = bik_rows+dbirj_rows+ndims_virial; - //printf("----- dbirj_rows: %d\n", dbirj_rows); - //printf("----- end of dbirj length.\n"); - -} - -/* ---------------------------------------------------------------------- - compute array length -------------------------------------------------------------------------- */ - -double ComputeSnapneigh::compute_scalar() -{ - if (dbirjflag) get_dbirj_length(); - return size_array_rows; -} - -/* ---------------------------------------------------------------------- - memory usage -------------------------------------------------------------------------- */ - -double ComputeSnapneigh::memory_usage() -{ - - double bytes = (double)size_array_rows*size_array_cols * - sizeof(double); // array - - return bytes; -} diff --git a/src/ML-SNAP/compute_snapneigh.h b/src/ML-SNAP/compute_snapneigh.h deleted file mode 100644 index 1ac712a101..0000000000 --- a/src/ML-SNAP/compute_snapneigh.h +++ /dev/null @@ -1,73 +0,0 @@ -/* -*- c++ -*- ---------------------------------------------------------- - LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator - https://www.lammps.org/, Sandia National Laboratories - Steve Plimpton, sjplimp@sandia.gov - - Copyright (2003) Sandia Corporation. Under the terms of Contract - DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains - certain rights in this software. This software is distributed under - the GNU General Public License. - - See the README file in the top-level LAMMPS directory. -------------------------------------------------------------------------- */ - -#ifdef COMPUTE_CLASS -// clang-format off -ComputeStyle(snapneigh,ComputeSnapneigh); -// clang-format on -#else - -#ifndef LMP_COMPUTE_SNAPNEIGH_H -#define LMP_COMPUTE_SNAPNEIGH_H - -#include "compute.h" - -namespace LAMMPS_NS { - -class ComputeSnapneigh : public Compute { - public: - ComputeSnapneigh(class LAMMPS *, int, char **); - ~ComputeSnapneigh() override; - void init() override; - void init_list(int, class NeighList *) override; - void compute_array() override; - double compute_scalar() override; - double memory_usage() override; - - private: - FILE * fh_d; - int natoms, nmax, size_peratom, lastcol; - int ncoeff, nperdim, yoffset, zoffset; - int ndims_peratom, ndims_force, ndims_virial; - double **cutsq; - class NeighList *list; - double **snap, **snapall; - double **snap_peratom; - double rcutfac; - double *radelem; - double *wjelem; - int *map; // map types to [0,nelements) - int nelements, chemflag; - int switchinnerflag; - double *sinnerelem; - double *dinnerelem; - //class SNA *snaptr; - double cutmax; - int quadraticflag; - //int bikflag; - //int bik_rows; - int bikflag, bik_rows, dbirjflag, dbirj_rows; - double **dbirj; - double **dbiri; // dBi/dRi = sum(-dBi/dRj) over neighbors j - int *nneighs; // number of neighs inside the snap cutoff. - int *neighsum; - int *icounter; // counting atoms i for each j. - double **neighs; // neighborlist for neural networks - - void get_dbirj_length(); -}; - -} // namespace LAMMPS_NS - -#endif -#endif From 1099199e9303107eee6d2e7649fcaf57165c20f8 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 22 Jun 2022 14:22:23 -0400 Subject: [PATCH 428/585] remove any remap related documentation. add paragraph about file compatibility --- doc/src/read_restart.rst | 55 ++++++++++++++++++++-------------------- 1 file changed, 27 insertions(+), 28 deletions(-) diff --git a/doc/src/read_restart.rst b/doc/src/read_restart.rst index b593fd51ae..f3065a2a5c 100644 --- a/doc/src/read_restart.rst +++ b/doc/src/read_restart.rst @@ -11,7 +11,6 @@ Syntax read_restart file flag * file = name of binary restart file to read in -* flag = noremap (optional) Examples """""""" @@ -19,10 +18,8 @@ Examples .. code-block:: LAMMPS read_restart save.10000 - read_restart save.10000 noremap read_restart restart.* read_restart restart.*.mpiio - read_restart poly.*.% noremap Description """"""""""" @@ -40,20 +37,21 @@ processors in the current simulation and the settings of the changed by the :doc:`balance ` or :doc:`fix balance ` commands. -.. note:: - - When restart files are read, atoms are explicitly remapped back into - the simulation box and image flags updated accordingly. In most - cases this will not make a difference since writing a restart file - will also trigger a rebuild of the neighbor lists and remapping of - atoms into the simulation box. This extra remap results in some - overhead that can be avoided by appending the optional *noremap* flag - to the read_restart command. - Restart files are saved in binary format to enable exact restarts, meaning that the trajectories of a restarted run will precisely match those produced by the original run had it continued on. +The binary restart file format was not designed with backward, forward, +or cross-platform compatibility in mind, so the files are only expected +to be read correctly by the same LAMMPS executable on the same platform. +Changes to the architecture, compilation settings, or LAMMPS version can +render a restart file unreadable or it may read the data incorrectly. +If you want a more portable format, you can use the data file format as +created by the :doc:`write_data ` command. Binary restart +files can also be converted into a data file from the command line by +the LAMMPS executable that wrote them using the :ref:`-restart2data +` command line flag. + Several things can prevent exact restarts due to round-off effects, in which case the trajectories in the 2 runs will slowly diverge. These include running on a different number of processors or changing @@ -221,17 +219,17 @@ its calculations in a consistent manner. .. note:: - There are a handful of commands which can be used before or - between runs which may require a system initialization. Examples - include the "balance", "displace_atoms", "delete_atoms", "set" (some - options), and "velocity" (some options) commands. This is because - they can migrate atoms to new processors. Thus they will also discard - unused "state" information from fixes. You will know the discard has + There are a handful of commands which can be used before or between + runs which may require a system initialization. Examples include the + "balance", "displace_atoms", "delete_atoms", "set" (some options), + and "velocity" (some options) commands. This is because they can + migrate atoms to new processors. Thus they will also discard unused + "state" information from fixes. You will know the discard has occurred because a list of discarded fixes will be printed to the screen and log file, as explained above. This means that if you wish to retain that info in a restarted run, you must re-specify the - relevant fixes and computes (which create fixes) before those commands - are used. + relevant fixes and computes (which create fixes) before those + commands are used. Some pair styles, like the :doc:`granular pair styles `, also use a fix to store "state" information that persists from timestep to @@ -244,18 +242,19 @@ LAMMPS allows bond interactions (angle, etc) to be turned off or deleted in various ways, which can affect how their info is stored in a restart file. -If bonds (angles, etc) have been turned off by the :doc:`fix shake ` or :doc:`delete_bonds ` command, -their info will be written to a restart file as if they are turned on. -This means they will need to be turned off again in a new run after -the restart file is read. +If bonds (angles, etc) have been turned off by the :doc:`fix shake +` or :doc:`delete_bonds ` command, their info +will be written to a restart file as if they are turned on. This means +they will need to be turned off again in a new run after the restart +file is read. Bonds that are broken (e.g. by a bond-breaking potential) are written to the restart file as broken bonds with a type of 0. Thus these bonds will still be broken when the restart file is read. -Bonds that have been broken by the :doc:`fix bond/break ` command have disappeared from the -system. No information about these bonds is written to the restart -file. +Bonds that have been broken by the :doc:`fix bond/break +` command have disappeared from the system. No +information about these bonds is written to the restart file. ---------- From 7c44eac0a6bdc7359beda0a1950e64a89622b0a2 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Thu, 23 Jun 2022 11:43:14 -0600 Subject: [PATCH 429/585] Added more to README and obtain MPI settings from lammps Python module --- examples/snap/README.md | 14 ++++++- examples/snap/compute.snap.dat | 59 ----------------------------- examples/snap/compute_snap_dgrad.py | 20 +++++----- 3 files changed, 24 insertions(+), 69 deletions(-) delete mode 100644 examples/snap/compute.snap.dat diff --git a/examples/snap/README.md b/examples/snap/README.md index e1bd54ff37..305f920ae8 100644 --- a/examples/snap/README.md +++ b/examples/snap/README.md @@ -1 +1,13 @@ -See `compute_snap_dgrad.py` for a test that compares the dBi/dRj from compute snap (`dgradflag=1`) to the sum of dBi/dRj from usual compute snap (`dgradflag=0`). +This directory contains a variety of tests for the ML-SNAP package. These include: + +in.snap.Ta06A # SNAP linear Ta potential +in.snap.W.2940 # SNAP linear W potential +in.snap.hybrid.WSNAP.HePair # Hybrid overlay pair style for linear SNAP W potential and twobody tables for He-He and W-He +in.snap.WBe.PRB2019 # SNAP linear W/Be potential +in.snap.InP.JCPA2020 # SNAP linear InP potential using chem keyword (explicit multi-element) +in.snap.Mo_Chen # SNAP linear Mo potential +in.snap.compute # SNAP compute for training a linear model +in.snap.compute.quadratic # SNAP compute for training a quadratic model +in.snap.scale.Ni_Zuo_JCPA2020 # SNAP linear Ni potential with thermodynamic integration (fix adapt scale) + +compute_snap_dgrad.py # SNAP compute with dgradflag (dBi/dRj) for training a non-linear model diff --git a/examples/snap/compute.snap.dat b/examples/snap/compute.snap.dat deleted file mode 100644 index 60aa40fdd6..0000000000 --- a/examples/snap/compute.snap.dat +++ /dev/null @@ -1,59 +0,0 @@ -# Time-averaged data for fix snap -# TimeStep Number-of-rows -# Row c_snap[1] c_snap[2] c_snap[3] c_snap[4] c_snap[5] c_snap[6] c_snap[7] c_snap[8] c_snap[9] c_snap[10] c_snap[11] -0 55 -1 0 0 0 0 0 3.12659e+06 1.91282e+06 1.01756e+06 1.18149e+06 419003 2775.75 -2 0 0 0 0 0 0 -2617.97 -11804.8 -32003.5 -14156.5 -126.705 -3 0 0 0 0 0 0 -2414.16 -4239.67 -6275.15 -3852.23 -118.927 -4 0 0 0 0 0 0 2529.98 3883.7 6245.75 2522.89 103.66 -5 0 0 0 0 0 0 411.847 604.579 57.0959 1095.67 -188.806 -6 0 0 0 0 0 0 1541.86 4697.43 11841.7 5519.43 275.079 -7 0 0 0 0 0 0 -2870.68 -1447.5 4412.24 1032.92 -63.9586 -8 0 0 0 0 0 0 1193.62 7012.92 20475.9 9007.1 230.377 -9 0 0 0 0 0 0 4848.36 11241.9 22593.7 11630.3 42.8991 -10 0 0 0 0 0 0 -1770.07 -2679.25 -3788.5 -2555.62 -135.264 -11 0 0 0 0 0 0 -4969.62 -8016.32 -11201.8 -7220.33 -85.5022 -12 0 0 0 0 0 0 1641.76 3596.16 7806.47 3219.57 40.8509 -13 0 0 0 0 0 0 325.571 4349.75 13049 5826.43 27.2534 -14 0 0 0 0 0 0 5920.17 5611.27 846.546 2245.23 83.7477 -15 0 0 0 0 0 0 -888.529 -848.965 -1874.49 -290.268 -68.0047 -16 0 0 0 0 0 0 -1916.74 67.9945 4784.3 2143.56 -39.6058 -17 0 0 0 0 0 0 -4098.57 -10375.2 -22007.6 -10355 -200.101 -18 0 0 0 0 0 0 -2284.58 -6551.33 -15184.8 -7117.19 -67.4731 -19 0 0 0 0 0 0 -2737.86 -632.669 6669.64 2094.01 52.5289 -20 0 0 0 0 0 0 -2329.4 -41.9068 7566.17 1913.97 100.188 -21 0 0 0 0 0 0 -444.112 -2754.7 -8428.65 -3849.65 -122.932 -22 0 0 0 0 0 0 -70.5051 111.212 854.264 255.733 65.2259 -23 0 0 0 0 0 0 3554.61 12874.2 31397 14566.8 47.5973 -24 0 0 0 0 0 0 1865.24 2108.07 1180.27 1465.26 91.3443 -25 0 0 0 0 0 0 -889.973 2561.32 11256.4 4537.35 77.4022 -26 0 0 0 0 0 0 3550.36 106.913 -9710.14 -2944.98 144.241 -27 0 0 0 0 0 0 -4712.47 -8838.63 -14464.9 -8091.56 -224.069 -28 0 0 0 0 0 0 -2024.94 -4432.38 -9505.05 -4018.8 -207.602 -29 0 0 0 0 0 0 2379.69 4724.47 7670.76 5006.86 -23.6309 -30 0 0 0 0 0 0 376.992 1771.26 5976.85 2024.35 134.961 -31 0 0 0 0 0 0 1237.27 -1519.65 -9085.33 -3530.88 -43.4288 -32 0 0 0 0 0 0 583.161 6064.47 18404.5 7643.32 243.05 -33 0 0 0 0 0 0 -2538.86 -2021.15 691.987 -389.262 -141.239 -34 0 0 0 0 0 0 2885.38 5612.51 9715.93 5772.93 193.908 -35 0 0 0 0 0 0 -6048.23 -11209.3 -18774.1 -10567.4 -252.412 -36 0 0 0 0 0 0 -1418.32 -3619.88 -5764.64 -4231.84 203.031 -37 0 0 0 0 0 0 3007.44 1474.23 -3713.21 -994.284 140.462 -38 0 0 0 0 0 0 4888.42 4654.63 805.35 2190.37 43.3575 -39 0 0 0 0 0 0 969.58 3277.56 6218.65 3924.82 -58.9942 -40 0 0 0 0 0 0 2987.73 4234.51 5529.54 3085.54 43.2781 -41 0 0 0 0 0 0 810.067 -1872.94 -8730.18 -3125.43 -210.33 -42 0 0 0 0 0 0 2844.79 2986.48 1115.95 1588.01 123.161 -43 0 0 0 0 0 0 134.538 -4097.82 -14380.1 -6204.27 -19.7911 -44 0 0 0 0 0 0 -2999.2 -2447.09 1548.16 -1098.43 162.086 -45 0 0 0 0 0 0 -2288.5 -5930.54 -12773.2 -6503.71 -200.232 -46 0 0 0 0 0 0 -2625.62 -6290.98 -12970.9 -6562.73 -182.126 -47 0 0 0 0 0 0 -228.949 4114.07 13655.9 5798.77 32.8425 -48 0 0 0 0 0 0 2900.97 5126.05 7340.27 4953.94 90.5452 -49 0 0 0 0 0 0 1798.49 -1194.98 -9074.02 -3404.76 -11.9431 -50 0 0 0 0 0 0 -3.09692e+06 -3.518e+06 -4.33318e+06 -2.30338e+06 1.32116e+08 -51 0 0 0 0 0 0 -3.10721e+06 -3.53165e+06 -4.34977e+06 -2.31581e+06 1.28785e+08 -52 0 0 0 0 0 0 -3.10871e+06 -3.53788e+06 -4.36295e+06 -2.32103e+06 1.4248e+08 -53 0 0 0 0 0 0 3585.35 6805.98 11450.9 6458.62 914589 -54 0 0 0 0 0 0 -6674.27 -11551.6 -17884.1 -10474.7 -2.08251e+06 -55 0 0 0 0 0 0 -11913.9 -22733.1 -38858.2 -21261 -7.73337e+06 diff --git a/examples/snap/compute_snap_dgrad.py b/examples/snap/compute_snap_dgrad.py index 84d0b8113a..51a3c08132 100644 --- a/examples/snap/compute_snap_dgrad.py +++ b/examples/snap/compute_snap_dgrad.py @@ -13,14 +13,14 @@ from __future__ import print_function import sys import ctypes import numpy as np - -# uncomment this if running in parallel via mpi4py -#me = 0 -#from mpi4py import MPI -#me = MPI.COMM_WORLD.Get_rank() -#nprocs = MPI.COMM_WORLD.Get_size() - from lammps import lammps, LMP_TYPE_ARRAY, LMP_STYLE_GLOBAL + +# get MPI settings from LAMMPS + +lmp = lammps() +me = lmp.extract_setting("world_rank") +nprocs = lmp.extract_setting("world_size") + cmds = ["-screen", "none", "-log", "none"] lmp = lammps(cmdargs=cmds) @@ -82,10 +82,12 @@ if (twojmax % 2 == 0): nd = int(m*(m+1)*(2*m+1)/6) else: nd = int(m*(m+1)*(m+2)/3) -print(f"Number of descriptors based on twojmax : {nd}") +if me == 0: + print(f"Number of descriptors based on twojmax : {nd}") # Run lammps with dgradflag on -print("Running with dgradflag on") +if me == 0: + print("Running with dgradflag on") run_lammps(1) # Get global snap array From 447c83662955547687d4018a2084aa45132077b2 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Thu, 23 Jun 2022 11:56:46 -0600 Subject: [PATCH 430/585] Reverted in.snap.compute --- examples/snap/in.snap.compute | 6 +++--- 1 file changed, 3 insertions(+), 3 deletions(-) diff --git a/examples/snap/in.snap.compute b/examples/snap/in.snap.compute index 005ba8b1a3..b0c7314882 100644 --- a/examples/snap/in.snap.compute +++ b/examples/snap/in.snap.compute @@ -3,7 +3,7 @@ # initialize simulation variable nsteps index 0 -variable nrep equal 2 +variable nrep equal 1 variable a equal 2.0 units metal @@ -81,7 +81,7 @@ thermo 100 # test output: 1: total potential energy # 2: xy component of stress tensor -# 3: Sum(B_{000}^i, all i of type 2) +# 3: Sum(B_{000}^i, all i of type 2) # 4: xz component of Sum(Sum(r_j*dB_{222}^i/dR[j]), all i of type 2), all j) # 5: y component of -Sum(d(B_{222}^i)/dR[2]), all i of type 2) # @@ -89,7 +89,7 @@ thermo 100 thermo_style custom & pe pxy c_bsum2[1] c_vbsum[55] v_db_2_25 & - c_snap[1][11] c_snap[13][11] c_snap[1][6] c_snap[12][10] c_snap[6][10] + c_snap[1][11] c_snap[13][11] c_snap[1][6] c_snap[12][10] c_snap[6][10] thermo_modify norm no # dump mydump_db all custom 1000 dump_db id c_db[*] From 2bc50791aad559ef9b57045c848ad5b810d05645 Mon Sep 17 00:00:00 2001 From: rohskopf Date: Thu, 23 Jun 2022 12:16:42 -0600 Subject: [PATCH 431/585] Clean up files. --- python/examples/in.lj | 25 ------------------------- python/lammps/mliap/__init__.py | 3 +-- src/ML-SNAP/compute_snap.h | 2 -- src/ML-SNAP/sna.cpp | 3 --- 4 files changed, 1 insertion(+), 32 deletions(-) delete mode 100644 python/examples/in.lj diff --git a/python/examples/in.lj b/python/examples/in.lj deleted file mode 100644 index 3dc80bdfea..0000000000 --- a/python/examples/in.lj +++ /dev/null @@ -1,25 +0,0 @@ -# 3d Lennard-Jones melt - -units lj -atom_style atomic -atom_modify map array - -lattice fcc 0.8442 -region box block 0 4 0 4 0 4 -create_box 1 box -create_atoms 1 box -mass 1 1.0 - -velocity all create 1.44 87287 loop geom - -pair_style lj/cut 2.5 -pair_coeff 1 1 1.0 1.0 2.5 - -neighbor 0.3 bin -neigh_modify delay 0 every 20 check no - -fix 1 all nve - -variable fx atom fx - -run 10 diff --git a/python/lammps/mliap/__init__.py b/python/lammps/mliap/__init__.py index 57a9eadd7e..57fe97d803 100644 --- a/python/lammps/mliap/__init__.py +++ b/python/lammps/mliap/__init__.py @@ -4,8 +4,7 @@ # try to improperly start up a new interpreter. import sysconfig import ctypes -#library = sysconfig.get_config_vars('INSTSONAME')[0] -library="/usr/local/Cellar/python@3.10/3.10.4/Frameworks/Python.framework/Versions/3.10/Python" +library = sysconfig.get_config_vars('INSTSONAME')[0] try: pylib = ctypes.CDLL(library) except OSError as e: diff --git a/src/ML-SNAP/compute_snap.h b/src/ML-SNAP/compute_snap.h index 447f6d286d..8dc72c3bd5 100644 --- a/src/ML-SNAP/compute_snap.h +++ b/src/ML-SNAP/compute_snap.h @@ -54,8 +54,6 @@ class ComputeSnap : public Compute { class SNA *snaptr; double cutmax; int quadraticflag; - //int bikflag; - //int bik_rows; int bikflag, bik_rows, dgradflag, dgrad_rows; double **dgrad; double **dbiri; // dBi/dRi = sum(-dBi/dRj) over neighbors j diff --git a/src/ML-SNAP/sna.cpp b/src/ML-SNAP/sna.cpp index d71eeaa7cb..30ae30ae4f 100644 --- a/src/ML-SNAP/sna.cpp +++ b/src/ML-SNAP/sna.cpp @@ -776,7 +776,6 @@ void SNA::compute_dbidrj() int elem3 = elem_duarray; - //printf("----- idxb_max: %d\n", idxb_max); for (int jjb = 0; jjb < idxb_max; jjb++) { const int j1 = idxb[jjb].j1; const int j2 = idxb[jjb].j2; @@ -1336,8 +1335,6 @@ double SNA::memory_usage() void SNA::create_twojmax_arrays() { - //printf("----- idxb_max: %d\n", idxb_max); - //printf("----- ntriples: %d\n", ntriples); int jdimpq = twojmax + 2; memory->create(rootpqarray, jdimpq, jdimpq, "sna:rootpqarray"); From 8e3a1e84a629e4776683c9acba3500abcdefed42 Mon Sep 17 00:00:00 2001 From: rohskopf Date: Thu, 23 Jun 2022 12:32:40 -0600 Subject: [PATCH 432/585] More cleaning up. --- python/examples/simple.py | 20 ++++++++++---------- src/ML-SNAP/compute_snap.h | 1 - 2 files changed, 10 insertions(+), 11 deletions(-) diff --git a/python/examples/simple.py b/python/examples/simple.py index 2f9c191165..8925ce48c0 100755 --- a/python/examples/simple.py +++ b/python/examples/simple.py @@ -5,10 +5,10 @@ # Purpose: mimic operation of examples/COUPLE/simple/simple.cpp via Python # Serial syntax: simple.py in.lammps -# in.simple = LAMMPS input script +# in.lammps = LAMMPS input script -# Parallel syntax: mpirun -np 4 python simple.py in.simple -# in.simple = LAMMPS input script +# Parallel syntax: mpirun -np 4 simple.py in.lammps +# in.lammps = LAMMPS input script # also need to uncomment mpi4py sections below from __future__ import print_function @@ -27,9 +27,9 @@ infile = sys.argv[1] me = 0 # uncomment this if running in parallel via mpi4py -from mpi4py import MPI -me = MPI.COMM_WORLD.Get_rank() -nprocs = MPI.COMM_WORLD.Get_size() +#from mpi4py import MPI +#me = MPI.COMM_WORLD.Get_rank() +#nprocs = MPI.COMM_WORLD.Get_size() from lammps import lammps lmp = lammps() @@ -122,10 +122,10 @@ if me == 0: print("Gather post scatter subset:", boxlo,boxhi,xy,yz,xz,periodicity,box_change = lmp.extract_box() if me == 0: print("Box info",boxlo,boxhi,xy,yz,xz,periodicity,box_change) -#lmp.reset_box([0,0,0],[10,10,8],0,0,0) +lmp.reset_box([0,0,0],[10,10,8],0,0,0) -#boxlo,boxhi,xy,yz,xz,periodicity,box_change = lmp.extract_box() -#if me == 0: print("Box info",boxlo,boxhi,xy,yz,xz,periodicity,box_change) +boxlo,boxhi,xy,yz,xz,periodicity,box_change = lmp.extract_box() +if me == 0: print("Box info",boxlo,boxhi,xy,yz,xz,periodicity,box_change) # uncomment if running in parallel via mpi4py -print("Proc %d out of %d procs has" % (me,nprocs), lmp) +#print("Proc %d out of %d procs has" % (me,nprocs), lmp) diff --git a/src/ML-SNAP/compute_snap.h b/src/ML-SNAP/compute_snap.h index 8dc72c3bd5..2a9a94ef80 100644 --- a/src/ML-SNAP/compute_snap.h +++ b/src/ML-SNAP/compute_snap.h @@ -35,7 +35,6 @@ class ComputeSnap : public Compute { double memory_usage() override; private: - FILE * fh_d; int natoms, nmax, size_peratom, lastcol; int ncoeff, nperdim, yoffset, zoffset; int ndims_peratom, ndims_force, ndims_virial; From 92ae5f656c000fdbdbf9b88f04b6cfd8ec28f6e7 Mon Sep 17 00:00:00 2001 From: rohskopf Date: Thu, 23 Jun 2022 12:45:20 -0600 Subject: [PATCH 433/585] Change docs. --- doc/src/compute_sna_atom.rst | 3 ++- 1 file changed, 2 insertions(+), 1 deletion(-) diff --git a/doc/src/compute_sna_atom.rst b/doc/src/compute_sna_atom.rst index e3255f201d..eddd65bac5 100644 --- a/doc/src/compute_sna_atom.rst +++ b/doc/src/compute_sna_atom.rst @@ -459,7 +459,8 @@ gradient components \frac{\partial {B_{i,k} }}{\partial {r}^a_j} where :math:`a` is the Cartesian direction for the gradient. The rows are organized in chunks, where each chunk corresponds to -an atom :math:`j` in the system of :math:`N` atoms. The rows in an atom :math:`j` chunk correspond to neighbors :math:`i` of :math:`j`. +an atom :math:`j` in the system of :math:`N` atoms. The rows in an atom +:math:`j` chunk correspond to atoms :math:`i` that have :math:`j` as a neighbor. The number of rows in the atom :math:`j` chunk is therefore equal to the number of neighbors :math:`N_{neighs}[j]` within the SNAP potential cutoff radius of atom :math:`j`, times 3 for each Cartesian direction. The total number of rows for these descriptor gradients is therefore From cf942e7d5f7af16b308a9e652cda8ccc78e2d19e Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 23 Jun 2022 15:54:04 -0400 Subject: [PATCH 434/585] may check for MPI library Fortran support only if MPI is enabled --- unittest/fortran/CMakeLists.txt | 9 ++++----- 1 file changed, 4 insertions(+), 5 deletions(-) diff --git a/unittest/fortran/CMakeLists.txt b/unittest/fortran/CMakeLists.txt index 94672a58d8..047dcf3207 100644 --- a/unittest/fortran/CMakeLists.txt +++ b/unittest/fortran/CMakeLists.txt @@ -10,11 +10,6 @@ if(NOT CMAKE_Fortran_COMPILER_ID) message(STATUS "Skipping Tests for the LAMMPS Fortran Module: cannot identify Fortran compiler") return() endif() -find_package(MPI QUIET) -if(BUILD_MPI AND NOT MPI_Fortran) - message(STATUS "Skipping Tests for the LAMMPS Fortran Module: no MPI support for Fortran") - return() -endif() if(CMAKE_Fortran_COMPILER) enable_language(C) @@ -22,6 +17,10 @@ if(CMAKE_Fortran_COMPILER) get_filename_component(LAMMPS_FORTRAN_MODULE ${LAMMPS_SOURCE_DIR}/../fortran/lammps.f90 ABSOLUTE) if(BUILD_MPI) find_package(MPI REQUIRED) + if((NOT MPI_Fortran) OR (NOT MPI_Fortran_HAVE_F77_HEADER) OR (NOT MPI_Fortran_HAVE_F90_MODULE)) + message(STATUS "Skipping Tests for the LAMMPS Fortran Module: no MPI support for Fortran") + return() + endif() else() add_library(fmpi_stubs STATIC mpi_stubs.f90) add_library(MPI::MPI_Fortran ALIAS fmpi_stubs) From 14d472d6911e4a3ea2709fb215452fabb0ab3071 Mon Sep 17 00:00:00 2001 From: rohskopf Date: Thu, 23 Jun 2022 16:30:53 -0600 Subject: [PATCH 435/585] First 3 columns are reference forces and indices, instead of last 3 columns. --- doc/src/compute_sna_atom.rst | 37 ++++++++----- examples/snap/compute_snap_dgrad.py | 9 ++-- src/ML-SNAP/compute_snap.cpp | 83 +++++++++++++++-------------- src/ML-SNAP/compute_snap.h | 3 +- 4 files changed, 72 insertions(+), 60 deletions(-) diff --git a/doc/src/compute_sna_atom.rst b/doc/src/compute_sna_atom.rst index eddd65bac5..e2655585f3 100644 --- a/doc/src/compute_sna_atom.rst +++ b/doc/src/compute_sna_atom.rst @@ -343,13 +343,16 @@ When the central atom and the neighbor atom have different types, the values of :math:`S_{inner}` and :math:`D_{inner}` are the arithmetic means of the values for both types. -The keyword *dgradflag* determines whether or not to sum the bispectrum descriptor gradients over neighboring atoms *i'* -as explained with *snad/atom* above. If *dgradflag* is set to 1 then the descriptor gradient rows of the global snap array -are not summed over atoms *i'*. Instead, each row corresponds to a single term :math:`\frac{\partial {B_{i,k} }}{\partial {r}^a_j}` +The keyword *dgradflag* determines whether or not to sum the bispectrum +descriptor gradients over neighboring atoms *i'* as explained with *snad/atom* +above. If *dgradflag* is set to 1 then the descriptor gradient rows of the +global snap array are not summed over atoms *i'*. Instead, each row corresponds +to a single term :math:`\frac{\partial {B_{i,k} }}{\partial {r}^a_j}` where :math:`a` is the Cartesian direction for the gradient. This also changes the number of columns to be equal to the number of bispectrum components, with 3 additional columns representing the indices :math:`i`, :math:`j`, and :math:`a`, -as explained more in the Output info section below. The option *dgradflag=1* must be used with *bikflag=1*. +as explained more in the Output info section below. The option *dgradflag=1* +must be used with *bikflag=1*. .. note:: @@ -458,12 +461,14 @@ gradient components \frac{\partial {B_{i,k} }}{\partial {r}^a_j} -where :math:`a` is the Cartesian direction for the gradient. The rows are organized in chunks, where each chunk corresponds to -an atom :math:`j` in the system of :math:`N` atoms. The rows in an atom -:math:`j` chunk correspond to atoms :math:`i` that have :math:`j` as a neighbor. -The number of rows in the atom :math:`j` chunk is therefore equal to the number of neighbors :math:`N_{neighs}[j]` within the SNAP -potential cutoff radius of atom :math:`j`, times 3 for each Cartesian direction. -The total number of rows for these descriptor gradients is therefore +where :math:`a` is the Cartesian direction for the gradient. The rows are +organized in chunks, where each chunk corresponds to an atom :math:`j` in the +system of :math:`N` atoms. The rows in an atom :math:`j` chunk correspond to +atoms :math:`i` that have :math:`j` as a neighbor. The number of rows in the +atom :math:`j` chunk is therefore equal to the number of neighbors +:math:`N_{neighs}[j]` within the SNAP potential cutoff radius of atom :math:`j` +, times 3 for each Cartesian direction. The total number of rows for these +descriptor gradients is therefore .. math:: @@ -472,10 +477,14 @@ The total number of rows for these descriptor gradients is therefore For *dgradflag=1*, the number of columns is equal to the number of bispectrum components, plus 3 additional columns representing the indices :math:`i`, :math:`j`, and :math:`a` which identify the atoms :math:`i` and :math:`j`, and Cartesian direction :math:`a` for which -a particular gradient :math:`\frac{\partial {B_{i,k} }}{\partial {r}^a_j}` belongs to. The reference energy and forces are also located in different parts of the array. -The last 3 columns of the first :math:`N` rows belong to the reference potential force components. -The first column of the last row, after the first :math:`N + 3 \sum_j^{N} N_{neighs}[j]` rows, -contains the reference potential energy. The virial components are not used with this option. +a particular gradient :math:`\frac{\partial {B_{i,k} }}{\partial {r}^a_j}` belongs to. +For the descriptor gradient rows, the first 3 columns contain the indices +:math:`i`, :math:`j`, and :math:`a`, and the remaining columns contain gradients +of different descriptors indexed by :math:`k`. +The first 3 columns of the first :math:`N` rows belong to the reference +potential force components. The first column of the last row, after the first +:math:`N + 3 \sum_j^{N} N_{neighs}[j]` rows, contains the reference potential +energy. The virial components are not used with this option. These values can be accessed by any command that uses per-atom values from a compute as input. See the :doc:`Howto output ` doc diff --git a/examples/snap/compute_snap_dgrad.py b/examples/snap/compute_snap_dgrad.py index 51a3c08132..259e44a504 100644 --- a/examples/snap/compute_snap_dgrad.py +++ b/examples/snap/compute_snap_dgrad.py @@ -95,11 +95,11 @@ lmp_snap = lmp.numpy.extract_compute("snap",0, 2) # Extract dBj/dRi (includes dBi/dRi) natoms = lmp.get_natoms() -fref1 = lmp_snap[0:natoms,-3:].flatten() +fref1 = lmp_snap[0:natoms,0:3].flatten() eref1 = lmp_snap[-1,0] #lmp_snap[-6,0] -dbdr_length = np.shape(lmp_snap)[0]-(natoms) - 1 #-6 # Length of neighborlist pruned dbdr array -dBdR = lmp_snap[natoms:(natoms+dbdr_length),:] -force_indices = lmp_snap[natoms:(natoms+dbdr_length),-3:].astype(np.int32) +dbdr_length = np.shape(lmp_snap)[0]-(natoms) - 1 # Length of neighborlist pruned dbdr array +dBdR = lmp_snap[natoms:(natoms+dbdr_length),3:(nd+3)] +force_indices = lmp_snap[natoms:(natoms+dbdr_length),0:3].astype(np.int32) # Sum over neighbors j for each atom i, like dgradflag=0 does. array1 = np.zeros((3*natoms,nd)) @@ -108,7 +108,6 @@ for k in range(0,nd): for l in range(0,dbdr_length): j = force_indices[l,0] i = force_indices[l,1] - #array1[3*(i-1)+a,k] += dBdR[l,k] array1[3*(i)+a,k] += dBdR[l,k] a = a+1 if (a>2): diff --git a/src/ML-SNAP/compute_snap.cpp b/src/ML-SNAP/compute_snap.cpp index 88360a5005..8a4ff2249e 100644 --- a/src/ML-SNAP/compute_snap.cpp +++ b/src/ML-SNAP/compute_snap.cpp @@ -541,11 +541,20 @@ void ComputeSnap::compute_array() } // linear contributions + int k; - if (dgradflag) k = 0; - else k = typeoffset_global; - for (int icoeff = 0; icoeff < ncoeff; icoeff++){ - snap[irow][k++] += snaptr->blist[icoeff]; + if (dgradflag){ + k = 0; + for (int icoeff = 0; icoeff < ncoeff; icoeff++){ + snap[irow][k+3] += snaptr->blist[icoeff]; + k = k+1; + } + } + else{ + k = typeoffset_global; + for (int icoeff = 0; icoeff < ncoeff; icoeff++){ + snap[irow][k++] += snaptr->blist[icoeff]; + } } // quadratic contributions @@ -585,29 +594,29 @@ void ComputeSnap::compute_array() irow = snap_row_indx + bik_rows; // x-coordinate - snap[irow][icoeff+typeoffset_global] += dgrad[dgrad_row_indx+0][icoeff]; + snap[irow][icoeff+3] += dgrad[dgrad_row_indx+0][icoeff]; if (icoeff==(ncoeff-1)){ - snap[irow][ncoeff] += dgrad[dgrad_row_indx+0][ncoeff]; - snap[irow][ncoeff+1] += dgrad[dgrad_row_indx+0][ncoeff+1]; - snap[irow][ncoeff+2] += dgrad[dgrad_row_indx+0][ncoeff+2]; + snap[irow][0] += dgrad[dgrad_row_indx+0][ncoeff]; + snap[irow][0+1] += dgrad[dgrad_row_indx+0][ncoeff+1]; + snap[irow][0+2] += dgrad[dgrad_row_indx+0][ncoeff+2]; } irow++; // y-coordinate - snap[irow][icoeff+typeoffset_global] += dgrad[dgrad_row_indx+1][icoeff]; + snap[irow][icoeff+3] += dgrad[dgrad_row_indx+1][icoeff]; if (icoeff==(ncoeff-1)){ - snap[irow][ncoeff] += dgrad[dgrad_row_indx+1][ncoeff]; - snap[irow][ncoeff+1] += dgrad[dgrad_row_indx+1][ncoeff+1]; - snap[irow][ncoeff+2] += dgrad[dgrad_row_indx+1][ncoeff+2]; + snap[irow][0] += dgrad[dgrad_row_indx+1][ncoeff]; + snap[irow][0+1] += dgrad[dgrad_row_indx+1][ncoeff+1]; + snap[irow][0+2] += dgrad[dgrad_row_indx+1][ncoeff+2]; } irow++; // z-coordinate - snap[irow][icoeff+typeoffset_global] += dgrad[dgrad_row_indx+2][icoeff]; + snap[irow][icoeff+3] += dgrad[dgrad_row_indx+2][icoeff]; if (icoeff==(ncoeff-1)){ - snap[irow][ncoeff] += dgrad[dgrad_row_indx+2][ncoeff]; - snap[irow][ncoeff+1] += dgrad[dgrad_row_indx+2][ncoeff+1]; - snap[irow][ncoeff+2] += dgrad[dgrad_row_indx+2][ncoeff+2]; + snap[irow][0] += dgrad[dgrad_row_indx+2][ncoeff]; + snap[irow][0+1] += dgrad[dgrad_row_indx+2][ncoeff+1]; + snap[irow][0+2] += dgrad[dgrad_row_indx+2][ncoeff+2]; } dbiri_indx = dbiri_indx+3; } @@ -617,29 +626,29 @@ void ComputeSnap::compute_array() irow = dbiri_indx + bik_rows; // x-coordinate - snap[irow][icoeff+typeoffset_global] += dbiri[3*i+0][icoeff]; + snap[irow][icoeff+3] += dbiri[3*i+0][icoeff]; if (icoeff==(ncoeff-1)){ - snap[irow][ncoeff] += dbiri[3*i+0][ncoeff]; - snap[irow][ncoeff+1] += dbiri[3*i+0][ncoeff+1]; - snap[irow][ncoeff+2] += dbiri[3*i+0][ncoeff+2]; + snap[irow][0] += dbiri[3*i+0][ncoeff]; + snap[irow][0+1] += dbiri[3*i+0][ncoeff+1]; + snap[irow][0+2] += dbiri[3*i+0][ncoeff+2]; } irow++; // y-coordinate - snap[irow][icoeff+typeoffset_global] += dbiri[3*i+1][icoeff]; + snap[irow][icoeff+3] += dbiri[3*i+1][icoeff]; if (icoeff==(ncoeff-1)){ - snap[irow][ncoeff] += dbiri[3*i+1][ncoeff]; - snap[irow][ncoeff+1] += dbiri[3*i+1][ncoeff+1]; - snap[irow][ncoeff+2] += dbiri[3*i+1][ncoeff+2]; + snap[irow][0] += dbiri[3*i+1][ncoeff]; + snap[irow][0+1] += dbiri[3*i+1][ncoeff+1]; + snap[irow][0+2] += dbiri[3*i+1][ncoeff+2]; } irow++; // z-coordinate - snap[irow][icoeff+typeoffset_global] += dbiri[3*i+2][icoeff]; + snap[irow][icoeff+3] += dbiri[3*i+2][icoeff]; if (icoeff==(ncoeff-1)){ - snap[irow][ncoeff] += dbiri[3*i+2][ncoeff]; - snap[irow][ncoeff+1] += dbiri[3*i+2][ncoeff+1]; - snap[irow][ncoeff+2] += dbiri[3*i+2][ncoeff+2]; + snap[irow][0] += dbiri[3*i+2][ncoeff]; + snap[irow][0+1] += dbiri[3*i+2][ncoeff+1]; + snap[irow][0+2] += dbiri[3*i+2][ncoeff+2]; } dbiri_indx = dbiri_indx+3; @@ -672,12 +681,12 @@ void ComputeSnap::compute_array() // accumulate forces to global array if (dgradflag){ - // for dgradflag=1, put forces at last 3 columns of bik rows + // for dgradflag=1, put forces at first 3 columns of bik rows for (int i=0; inlocal; i++){ int iglobal = atom->tag[i]; - snap[iglobal-1][ncoeff+0] = atom->f[i][0]; - snap[iglobal-1][ncoeff+1] = atom->f[i][1]; - snap[iglobal-1][ncoeff+2] = atom->f[i][2]; + snap[iglobal-1][0+0] = atom->f[i][0]; + snap[iglobal-1][0+1] = atom->f[i][1]; + snap[iglobal-1][0+2] = atom->f[i][2]; } } @@ -793,18 +802,13 @@ void ComputeSnap::get_dgrad_length() int * const type = atom->type; const int* const mask = atom->mask; double** const x = atom->x; - /* - memory->create(neighsum, inum, "snap:neighsum"); - memory->create(nneighs, inum, "snap:nneighs"); - memory->create(icounter, inum, "snap:icounter"); - memory->create(dbiri, 3*atom->nlocal,ncoeff+3, "snap:dbiri"); - */ + memory->create(neighsum, natoms, "snap:neighsum"); memory->create(nneighs, natoms, "snap:nneighs"); memory->create(icounter, natoms, "snap:icounter"); memory->create(dbiri, 3*natoms,ncoeff+3, "snap:dbiri"); if (atom->nlocal != natoms){ - error->all(FLERR,"Compute snap dgradflag=1 does not support parallelism."); + error->all(FLERR,"Compute snap dgradflag=1 does not support parallelism yet."); } for (int ii=0; ii<3*natoms; ii++){ for (int icoeff=0; icoeffnlocal; // Add 3*N for dBi/dRi size_array_rows = bik_rows + dgrad_rows + 3*atom->nlocal + 1; // Add 3*N for dBi/dRi. and add 1 for reference energy memory->create(snap,size_array_rows,size_array_cols, "snap:snap"); diff --git a/src/ML-SNAP/compute_snap.h b/src/ML-SNAP/compute_snap.h index 2a9a94ef80..dcdf339b72 100644 --- a/src/ML-SNAP/compute_snap.h +++ b/src/ML-SNAP/compute_snap.h @@ -54,7 +54,8 @@ class ComputeSnap : public Compute { double cutmax; int quadraticflag; int bikflag, bik_rows, dgradflag, dgrad_rows; - double **dgrad; + double **dgrad; // First ncoeff columns are descriptor derivatives. + // Last 3 columns are indices i,j,a double **dbiri; // dBi/dRi = sum(-dBi/dRj) over neighbors j int *nneighs; // number of neighs inside the snap cutoff. int *neighsum; From db079cd62077645424af307790625161daafca90 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 23 Jun 2022 22:27:04 -0400 Subject: [PATCH 436/585] must set thirdparty download URL variable for downloading MPICH4Win --- cmake/Modules/LAMMPSInterfacePlugin.cmake | 3 +++ 1 file changed, 3 insertions(+) diff --git a/cmake/Modules/LAMMPSInterfacePlugin.cmake b/cmake/Modules/LAMMPSInterfacePlugin.cmake index ec7a739785..0cdf0bb564 100644 --- a/cmake/Modules/LAMMPSInterfacePlugin.cmake +++ b/cmake/Modules/LAMMPSInterfacePlugin.cmake @@ -6,6 +6,9 @@ if(${CMAKE_SOURCE_DIR} STREQUAL ${CMAKE_BINARY_DIR}) "Please remove CMakeCache.txt and CMakeFiles first.") endif() +set(LAMMPS_THIRDPARTY_URL "https://download.lammps.org/thirdparty" + CACHE STRING "URL for thirdparty package downloads") + # global LAMMPS/plugin build settings set(LAMMPS_SOURCE_DIR "" CACHE PATH "Location of LAMMPS sources folder") if(NOT LAMMPS_SOURCE_DIR) From 6273e593a35d96585b2c7b68d4b15150ca8097d3 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 23 Jun 2022 23:09:13 -0400 Subject: [PATCH 437/585] add "package" target to support building a windows installer with NSIS --- cmake/Modules/LAMMPSInterfacePlugin.cmake | 7 +++++++ examples/PACKAGES/pace/plugin/CMakeLists.txt | 17 +++++++++++++++++ 2 files changed, 24 insertions(+) diff --git a/cmake/Modules/LAMMPSInterfacePlugin.cmake b/cmake/Modules/LAMMPSInterfacePlugin.cmake index 0cdf0bb564..d80d7609b7 100644 --- a/cmake/Modules/LAMMPSInterfacePlugin.cmake +++ b/cmake/Modules/LAMMPSInterfacePlugin.cmake @@ -81,6 +81,13 @@ function(get_newest_file path variable) set(${variable} ${_bestfile} PARENT_SCOPE) endfunction() +# get LAMMPS version date +function(get_lammps_version version_header variable) + file(STRINGS ${version_header} line REGEX LAMMPS_VERSION) + string(REGEX REPLACE "#define LAMMPS_VERSION \"([0-9]+) ([A-Za-z]+) ([0-9]+)\"" "\\1\\2\\3" date "${line}") + set(${variable} "${date}" PARENT_SCOPE) +endfunction() + ################################################################################# # LAMMPS C++ interface. We only need the header related parts except on windows. add_library(lammps INTERFACE) diff --git a/examples/PACKAGES/pace/plugin/CMakeLists.txt b/examples/PACKAGES/pace/plugin/CMakeLists.txt index f4068a03c9..6ad9c791ba 100644 --- a/examples/PACKAGES/pace/plugin/CMakeLists.txt +++ b/examples/PACKAGES/pace/plugin/CMakeLists.txt @@ -31,6 +31,23 @@ elseif(CMAKE_SYSTEM_NAME STREQUAL "Windows") if(CMAKE_CROSSCOMPILING) set_target_properties(paceplugin PROPERTIES LINK_FLAGS "-Wl,--export-all-symbols") endif() + + get_lammps_version(${LAMMPS_SOURCE_DIR}/version.h LAMMPS_VERSION) + find_program(MAKENSIS_PATH makensis) + if(MAKENSIS_PATH) + execute_process(COMMAND ${CMAKE_COMMAND} -E copy_if_different ${CMAKE_SOURCE_DIR}/lammps.ico + ${CMAKE_SOURCE_DIR}/lammps-text-logo-wide.bmp ${CMAKE_SOURCE_DIR}/paceplugin.nsis ${CMAKE_BINARY_DIR}) + if(BUILD_MPI) + add_custom_target(package ${MAKENSIS_PATH} -V1 -DVERSION=${LAMMPS_VERSION}-MPI paceplugin.nsis + DEPENDS paceplugin + BYPRODUCTS LAMMPS-ML-PACE-plugin-${LAMMPS_VERSION}-MPI.exe) + else() + add_custom_target(package ${MAKENSIS_PATH} -V1 -DVERSION=${LAMMPS_VERSION} paceplugin.nsis + COMMAND ${CMAKE_COMMAND} -E echo ${PWD} + DEPENDS paceplugin lammps.ico lammps-text-logo-wide.bmp paceplugin.nsis + BYPRODUCTS LAMMPS-ML-PACE-plugin-${LAMMPS_VERSION}.exe) + endif() + endif() else() set_target_properties(paceplugin PROPERTIES LINK_FLAGS "-rdynamic") endif() From ad3387143aaf1ee18c111d7fb1f9889f1c4f153f Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 24 Jun 2022 06:18:22 -0400 Subject: [PATCH 438/585] add crosscompiling with MPI support to plugins package --- cmake/Modules/LAMMPSInterfacePlugin.cmake | 1 + examples/plugins/LAMMPSInterfaceCXX.cmake | 57 +++++++++++++++++++++-- 2 files changed, 54 insertions(+), 4 deletions(-) diff --git a/cmake/Modules/LAMMPSInterfacePlugin.cmake b/cmake/Modules/LAMMPSInterfacePlugin.cmake index d80d7609b7..95bb707e86 100644 --- a/cmake/Modules/LAMMPSInterfacePlugin.cmake +++ b/cmake/Modules/LAMMPSInterfacePlugin.cmake @@ -99,6 +99,7 @@ endif() ################################################################################ # MPI configuration if(NOT CMAKE_CROSSCOMPILING) + set(MPI_CXX_SKIP_MPICXX TRUE) find_package(MPI QUIET) option(BUILD_MPI "Build MPI version" ${MPI_FOUND}) else() diff --git a/examples/plugins/LAMMPSInterfaceCXX.cmake b/examples/plugins/LAMMPSInterfaceCXX.cmake index d52cf8f4e5..a3313215d6 100644 --- a/examples/plugins/LAMMPSInterfaceCXX.cmake +++ b/examples/plugins/LAMMPSInterfaceCXX.cmake @@ -1,6 +1,9 @@ # Cmake script code to define the LAMMPS C++ interface # settings required for building LAMMPS plugins +set(LAMMPS_THIRDPARTY_URL "https://download.lammps.org/thirdparty" + CACHE STRING "URL for thirdparty package downloads") + ################################################################################ # helper function function(validate_option name values) @@ -37,10 +40,56 @@ else() endif() if(BUILD_MPI) - find_package(MPI REQUIRED) - option(LAMMPS_LONGLONG_TO_LONG "Workaround if your system or MPI version does not recognize 'long long' data types" OFF) - if(LAMMPS_LONGLONG_TO_LONG) - target_compile_definitions(lammps INTERFACE -DLAMMPS_LONGLONG_TO_LONG) + # do not include the (obsolete) MPI C++ bindings which makes + # for leaner object files and avoids namespace conflicts + set(MPI_CXX_SKIP_MPICXX TRUE) + # We use a non-standard procedure to cross-compile with MPI on Windows + if((CMAKE_SYSTEM_NAME STREQUAL "Windows") AND CMAKE_CROSSCOMPILING) + # Download and configure custom MPICH files for Windows + message(STATUS "Downloading and configuring MPICH-1.4.1 for Windows") + set(MPICH2_WIN64_DEVEL_URL "${LAMMPS_THIRDPARTY_URL}/mpich2-win64-devel.tar.gz" CACHE STRING "URL for MPICH2 (win64) tarball") + set(MPICH2_WIN32_DEVEL_URL "${LAMMPS_THIRDPARTY_URL}/mpich2-win32-devel.tar.gz" CACHE STRING "URL for MPICH2 (win32) tarball") + set(MPICH2_WIN64_DEVEL_MD5 "4939fdb59d13182fd5dd65211e469f14" CACHE STRING "MD5 checksum of MPICH2 (win64) tarball") + set(MPICH2_WIN32_DEVEL_MD5 "a61d153500dce44e21b755ee7257e031" CACHE STRING "MD5 checksum of MPICH2 (win32) tarball") + mark_as_advanced(MPICH2_WIN64_DEVEL_URL) + mark_as_advanced(MPICH2_WIN32_DEVEL_URL) + mark_as_advanced(MPICH2_WIN64_DEVEL_MD5) + mark_as_advanced(MPICH2_WIN32_DEVEL_MD5) + + include(ExternalProject) + if(CMAKE_SYSTEM_PROCESSOR STREQUAL "x86_64") + ExternalProject_Add(mpi4win_build + URL ${MPICH2_WIN64_DEVEL_URL} + URL_MD5 ${MPICH2_WIN64_DEVEL_MD5} + CONFIGURE_COMMAND "" BUILD_COMMAND "" INSTALL_COMMAND "" + BUILD_BYPRODUCTS /lib/libmpi.a) + else() + ExternalProject_Add(mpi4win_build + URL ${MPICH2_WIN32_DEVEL_URL} + URL_MD5 ${MPICH2_WIN32_DEVEL_MD5} + CONFIGURE_COMMAND "" BUILD_COMMAND "" INSTALL_COMMAND "" + BUILD_BYPRODUCTS /lib/libmpi.a) + endif() + + ExternalProject_get_property(mpi4win_build SOURCE_DIR) + file(MAKE_DIRECTORY "${SOURCE_DIR}/include") + add_library(MPI::MPI_CXX UNKNOWN IMPORTED) + set_target_properties(MPI::MPI_CXX PROPERTIES + IMPORTED_LOCATION "${SOURCE_DIR}/lib/libmpi.a" + INTERFACE_INCLUDE_DIRECTORIES "${SOURCE_DIR}/include" + INTERFACE_COMPILE_DEFINITIONS "MPICH_SKIP_MPICXX") + add_dependencies(MPI::MPI_CXX mpi4win_build) + + # set variables for status reporting at the end of CMake run + set(MPI_CXX_INCLUDE_PATH "${SOURCE_DIR}/include") + set(MPI_CXX_COMPILE_DEFINITIONS "MPICH_SKIP_MPICXX") + set(MPI_CXX_LIBRARIES "${SOURCE_DIR}/lib/libmpi.a") + else() + find_package(MPI REQUIRED) + option(LAMMPS_LONGLONG_TO_LONG "Workaround if your system or MPI version does not recognize 'long long' data types" OFF) + if(LAMMPS_LONGLONG_TO_LONG) + target_compile_definitions(lammps INTERFACE -DLAMMPS_LONGLONG_TO_LONG) + endif() endif() target_link_libraries(lammps INTERFACE MPI::MPI_CXX) else() From 7a5410a085499a48bc082d526d823b0beb0a9dc5 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Fri, 24 Jun 2022 15:09:15 -0600 Subject: [PATCH 439/585] support for >ELEMENTS MDI command --- examples/mdi/Run.sh | 10 ++-- src/MDI/fix_mdi_qm.cpp | 51 +++++++++++++++++-- src/MDI/fix_mdi_qm.h | 2 + src/MDI/mdi_engine.cpp | 110 ++++++++++++++++++++++++++++++++++------- src/MDI/mdi_engine.h | 3 ++ 5 files changed, 149 insertions(+), 27 deletions(-) diff --git a/examples/mdi/Run.sh b/examples/mdi/Run.sh index 3817841103..3b70a8bf79 100644 --- a/examples/mdi/Run.sh +++ b/examples/mdi/Run.sh @@ -3,7 +3,7 @@ # ------------------------------------------------- # ------------------------------------------------- -# Example 1 +# Example 1 = run ab initio MD (AIMD) # --- @@ -56,7 +56,7 @@ mv log.aimd.engine.plugin log.aimd.engine.plugin.3 # ------------------------------------------------- # ------------------------------------------------- -# Example 2 +# Example 2 = run LAMMPS, compute QM forces on snapshots from a long run # --- @@ -116,7 +116,7 @@ mv dump.snapshot.driver.plugin dump.snapshot.driver.plugin.3 # ------------------------------------------------- # ------------------------------------------------- -# Example 3 +# Example 3 = run LAMMPS, compute QM forces on series of independent systems # --- @@ -176,7 +176,7 @@ mv dump.series.driver.plugin dump.series.driver.plugin.3 # ------------------------------------------------- # ------------------------------------------------- -# Example 4 +# Example 4 = Python driver runs a sequence of unrelated LAMMPS calculations # --- @@ -221,7 +221,7 @@ mpirun -np 3 python3 sequence_driver.py -plugin lammps -mdi "-role DRIVER -name # ------------------------------------------------- # ------------------------------------------------- -# Example 5 +# Example 5 = run AIMD with Python driver code and 2 LAMMPS instances as engines # --- diff --git a/src/MDI/fix_mdi_qm.cpp b/src/MDI/fix_mdi_qm.cpp index 38b7270651..1c725a0871 100644 --- a/src/MDI/fix_mdi_qm.cpp +++ b/src/MDI/fix_mdi_qm.cpp @@ -25,6 +25,8 @@ using namespace FixConst; enum { NATIVE, REAL, METAL }; // LAMMPS units which MDI supports +#define MAXELEMENT 103 // used elsewhere in MDI package + /* ---------------------------------------------------------------------- */ FixMDIQM::FixMDIQM(LAMMPS *lmp, int narg, char **arg) : Fix(lmp, narg, arg) @@ -49,6 +51,7 @@ FixMDIQM::FixMDIQM(LAMMPS *lmp, int narg, char **arg) : Fix(lmp, narg, arg) addflag = 1; every = 1; connectflag = 1; + elements = nullptr; int iarg = 3; while (iarg < narg) { @@ -75,6 +78,17 @@ FixMDIQM::FixMDIQM(LAMMPS *lmp, int narg, char **arg) : Fix(lmp, narg, arg) else if (strcmp(arg[iarg+1],"no") == 0) connectflag = 0; else error->all(FLERR,"Illegal fix mdi/qm command"); iarg += 2; + } else if (strcmp(arg[iarg],"elements") == 0) { + int ntypes = atom->ntypes; + if (iarg+ntypes+1 > narg) error->all(FLERR,"Illegal fix mdi/qm command"); + delete [] elements; + elements = new int[ntypes+1]; + for (int i = 1; i <= ntypes; i++) { + elements[i] = utils::inumeric(FLERR,arg[iarg+i],false,lmp); + if (elements[i] < 1 || elements[i] > MAXELEMENT) + error->all(FLERR,"Illegal fix mdi/qm command"); + } + iarg += ntypes+1; } else error->all(FLERR,"Illegal fix mdi/qm command"); } @@ -154,6 +168,8 @@ FixMDIQM::~FixMDIQM() // clean up + delete[] elements; + memory->destroy(fqm); memory->destroy(ibuf1); @@ -220,7 +236,7 @@ void FixMDIQM::init() } } - // send natoms, atom types, and simulation box to engine + // send natoms, atom types or elements, and simulation box to engine // this will trigger setup of a new system // subsequent calls in post_force() will be for same system until new init() @@ -232,7 +248,8 @@ void FixMDIQM::init() ierr = MDI_Send(&n, 1, MDI_INT, mdicomm); if (ierr) error->all(FLERR, "MDI: >NATOMS data"); - send_types(); + if (elements) send_elements(); + else send_types(); send_box(); } @@ -420,7 +437,7 @@ void FixMDIQM::reallocate() } /* ---------------------------------------------------------------------- - send numeric atom types to MDI engine + send LAMMPS atom types to MDI engine ------------------------------------------------------------------------- */ void FixMDIQM::send_types() @@ -448,6 +465,34 @@ void FixMDIQM::send_types() if (ierr) error->all(FLERR, "MDI: >TYPES data"); } +/* ---------------------------------------------------------------------- + send elements to MDI engine = atomic numbers for each type +------------------------------------------------------------------------- */ + +void FixMDIQM::send_elements() +{ + int n = static_cast (atom->natoms); + memset(ibuf1, 0, n * sizeof(int)); + + // use local atomID to index into ordered ibuf1 + + tagint *tag = atom->tag; + int *type = atom->type; + int nlocal = atom->nlocal; + + int index; + for (int i = 0; i < nlocal; i++) { + index = static_cast(tag[i]) - 1; + ibuf1[index] = elements[type[i]]; + } + + MPI_Reduce(ibuf1, ibuf1all, n, MPI_INT, MPI_SUM, 0, world); + + int ierr = MDI_Send_command(">ELEMENTS", mdicomm); + if (ierr) error->all(FLERR, "MDI: >ELEMENTS command"); + ierr = MDI_Send(ibuf1all, n, MDI_INT, mdicomm); + if (ierr) error->all(FLERR, "MDI: >ELEMETNS data"); +} /* ---------------------------------------------------------------------- send simulation box size and shape to MDI engine diff --git a/src/MDI/fix_mdi_qm.h b/src/MDI/fix_mdi_qm.h index 1db6a0cce2..11180925b1 100644 --- a/src/MDI/fix_mdi_qm.h +++ b/src/MDI/fix_mdi_qm.h @@ -44,6 +44,7 @@ class FixMDIQM : public Fix { int plugin; int maxlocal; int sumflag; + int *elements; double qm_energy; int lmpunits; @@ -70,6 +71,7 @@ class FixMDIQM : public Fix { void reallocate(); void send_types(); + void send_elements(); void send_box(); void unit_conversions(); }; diff --git a/src/MDI/mdi_engine.cpp b/src/MDI/mdi_engine.cpp index 3683e3f3c5..79bfbe097e 100644 --- a/src/MDI/mdi_engine.cpp +++ b/src/MDI/mdi_engine.cpp @@ -54,6 +54,8 @@ enum { DEFAULT, MD, OPT }; // top-level MDI engine modes enum { TYPE, CHARGE, MASS, COORD, VELOCITY, FORCE, ADDFORCE }; +#define MAXELEMENT 103 // used elsewhere in MDI package + /* ---------------------------------------------------------------------- trigger LAMMPS to start acting as an MDI engine either in standalone mode or plugin mode @@ -63,17 +65,47 @@ enum { TYPE, CHARGE, MASS, COORD, VELOCITY, FORCE, ADDFORCE }; when EXIT command is received, mdi engine command exits ---------------------------------------------------------------------- */ -MDIEngine::MDIEngine(LAMMPS *_lmp, int narg, char ** /*arg*/) : Pointers(_lmp) +MDIEngine::MDIEngine(LAMMPS *_lmp, int narg, char ** arg) : Pointers(_lmp) { - if (narg) error->all(FLERR, "Illegal mdi engine command"); - // check requirements for LAMMPS to work with MDI as an engine - if (atom->tag_enable == 0) error->all(FLERR, "Cannot use MDI engine without atom IDs"); + if (atom->tag_enable == 0) error->all(FLERR, "MDI engine requires atom IDs"); if (atom->natoms && atom->tag_consecutive() == 0) error->all(FLERR, "MDI engine requires consecutive atom IDs"); + // optional args + + elements = nullptr; + + int iarg = 0; + while (iarg < narg) { + if (strcmp(arg[iarg],"elements") == 0) { + int ntypes = atom->ntypes; + delete [] elements; + elements = new int[ntypes+1]; + if (iarg+ntypes+1 > narg) error->all(FLERR,"Illegal mdi engine command"); + for (int i = 1; i <= ntypes; i++) { + elements[i] = utils::inumeric(FLERR,arg[iarg+i],false,lmp); + if (elements[i] < 0 || elements[i] > MAXELEMENT) + error->all(FLERR,"Illegal mdi engine command"); + } + iarg += ntypes+1; + } else error->all(FLERR,"Illegal mdi engine command"); + } + + // error check an MDI element does not map to multiple atom types + + if (elements) { + int ntypes = atom->ntypes; + for (int i = 1; i < ntypes; i++) + for (int j = i+1; j <= ntypes; j++) { + if (elements[i] == 0 || elements[j] == 0) continue; + if (elements[i] == elements[j]) + error->all(FLERR,"MDI engine element cannot map to multiple types"); + } + } + // confirm LAMMPS is being run as an engine int role; @@ -194,6 +226,8 @@ MDIEngine::MDIEngine(LAMMPS *_lmp, int narg, char ** /*arg*/) : Pointers(_lmp) // clean up + delete[] elements; + delete[] mdicmd; delete[] node_engine; delete[] node_driver; @@ -299,6 +333,11 @@ int MDIEngine::execute_command(const char *command, MDI_Comm mdicomm) } else if (strcmp(command, ">COORDS") == 0) { receive_coords(); + } else if (strcmp(command, ">ELEMENTS") == 0) { + if (!elements) + error->all(FLERR,"MDI engine command did not define element list"); + receive_elements(); + } else if (strcmp(command, ">FORCES") == 0) { receive_double3(FORCE); @@ -323,7 +362,7 @@ int MDIEngine::execute_command(const char *command, MDI_Comm mdicomm) else receive_double3(VELOCITY); - // ----------------------------------------------- + // ----------------------------------------------- } else if (strcmp(command, "<@") == 0) { ierr = MDI_Send(node_engine, MDI_NAME_LENGTH, MDI_CHAR, mdicomm); @@ -372,9 +411,9 @@ int MDIEngine::execute_command(const char *command, MDI_Comm mdicomm) } else if (strcmp(command, "all(FLERR, "MDI: MDI engine is already performing a simulation"); @@ -419,14 +458,14 @@ int MDIEngine::execute_command(const char *command, MDI_Comm mdicomm) strncpy(node_driver, command, MDI_COMMAND_LENGTH); node_match = false; - // exit command + // exit command } else if (strcmp(command, "EXIT") == 0) { exit_command = true; - // ------------------------------------------------------- - // custom LAMMPS commands - // ------------------------------------------------------- + // ------------------------------------------------------- + // custom LAMMPS commands + // ------------------------------------------------------- } else if (strcmp(command, "NBYTES") == 0) { nbytes_command(); @@ -439,9 +478,9 @@ int MDIEngine::execute_command(const char *command, MDI_Comm mdicomm) } else if (strcmp(command, "all(FLERR, "MDI: Unknown command {} received from driver", command); @@ -479,6 +518,7 @@ void MDIEngine::mdi_commands() MDI_Register_command("@DEFAULT", ">CELL_DISPL"); MDI_Register_command("@DEFAULT", ">CHARGES"); MDI_Register_command("@DEFAULT", ">COORDS"); + MDI_Register_command("@DEFAULT", ">ELEMENTS"); MDI_Register_command("@DEFAULT", ">NATOMS"); MDI_Register_command("@DEFAULT", ">NSTEPS"); MDI_Register_command("@DEFAULT", ">TOLERANCE"); @@ -914,7 +954,7 @@ void MDIEngine::evaluate() /* ---------------------------------------------------------------------- create a new system - >CELL, >NATOMS, >TYPES, >COORDS commands are required + >CELL, >NATOMS, >TYPES or >ELEMENTS, >COORDS commands are required >CELL_DISPL, >CHARGES, >VELOCITIES commands are optional ---------------------------------------------------------------------- */ @@ -924,8 +964,8 @@ void MDIEngine::create_system() if (flag_cell == 0 || flag_natoms == 0 || flag_types == 0 || flag_coords == 0) error->all(FLERR, - "MDI create_system requires >CELL, >NATOMS, >TYPES, >COORDS " - "MDI commands"); + "MDI create_system requires >CELL, >NATOMS, " + ">TYPES or >ELEMENTS, >COORDS MDI commands"); // remove all existing atoms via delete_atoms command @@ -1160,6 +1200,38 @@ void MDIEngine::receive_coords() for (int i = 0; i < n; i++) sys_coords[i] *= mdi2lmp_length; } +/* ---------------------------------------------------------------------- + >ELEMENTS command + receive elements for each atom = atomic numbers + convert to LAMMPS atom types and store in sys_types +---------------------------------------------------------------------- */ + +void MDIEngine::receive_elements() +{ + actionflag = 0; + flag_types = 1; + int ierr = MDI_Recv(sys_types, sys_natoms, MDI_INT, mdicomm); + if (ierr) error->all(FLERR, "MDI: >ELEMENTS data"); + MPI_Bcast(sys_types, sys_natoms, MPI_INT, 0, world); + + // convert from element atomic numbers to LAMMPS atom types + // use maping provided by mdi engine command + + int ntypes = atom->ntypes; + int itype; + + for (int i = 0; i < sys_natoms; i++) { + for (itype = 1; itype <= ntypes; itype++) { + if (sys_types[i] == elements[itype]) { + sys_types[i] = itype; + break; + } + } + if (itype > ntypes) + error->all(FLERR,"MDI element not found in element list"); + } +} + /* ---------------------------------------------------------------------- >NATOMS command natoms cannot exceed 32-bit int for use with MDI diff --git a/src/MDI/mdi_engine.h b/src/MDI/mdi_engine.h index ea840fba02..242755e3b7 100644 --- a/src/MDI/mdi_engine.h +++ b/src/MDI/mdi_engine.h @@ -70,6 +70,8 @@ class MDIEngine : protected Pointers { int actionflag; // 1 if MD or OPTG just completed, else 0 + int *elements; + // buffers for MDI comm int maxatom; @@ -106,6 +108,7 @@ class MDIEngine : protected Pointers { void receive_cell_displ(); void receive_charges(); void receive_coords(); + void receive_elements(); void receive_natoms(); void receive_nsteps(); void receive_tolerance(); From 1c709eb1ef9118eb3b3601fdd8013ccdce7bbeab Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Fri, 24 Jun 2022 15:31:09 -0600 Subject: [PATCH 440/585] udpate doc pages for ELEMENTS command --- doc/src/fix_mdi_qm.rst | 19 +++++++++++++++++-- doc/src/mdi.rst | 41 ++++++++++++++++++++++++++++++++--------- 2 files changed, 49 insertions(+), 11 deletions(-) diff --git a/doc/src/fix_mdi_qm.rst b/doc/src/fix_mdi_qm.rst index 8ecb6ed488..a00f6e2edc 100644 --- a/doc/src/fix_mdi_qm.rst +++ b/doc/src/fix_mdi_qm.rst @@ -13,7 +13,7 @@ Syntax * ID, group-ID are documented in :doc:`fix ` command * mdi/qm = style name of this fix command * zero or more keyword/value pairs may be appended -* keyword = *virial* or *add* or *every* or *connect* +* keyword = *virial* or *add* or *every* or *connect* or *elements* .. parsed-literal:: @@ -28,6 +28,8 @@ Syntax *connect* args = *yes* or *no* yes = perform a one-time connection to the MDI engine code no = do not perform the connection operation + *elements* args = N_1 N_2 ... N_ntypes + N_1,N_2,...N_ntypes = atomic number for each of ntypes LAMMPS atom types Examples """""""" @@ -36,7 +38,7 @@ Examples fix 1 all mdi/qm fix 1 all mdi/qm virial yes - fix 1 all mdi/qm add no every 100 + fix 1 all mdi/qm add no every 100 elements 13 29 Description """"""""""" @@ -118,6 +120,19 @@ series of system configurations. In this use case *connect no* is used along with the :doc:`mdi connect and exit ` command to one-time initiate/terminate the connection outside the loop. +The *elements* keyword allows specification of what element each +LAMMPS atom type corresponds to. This is specified by the atomic +number of the element, e.g. 13 for Al. An atomic number must be +specified for each of the ntypes LAMMPS atom types. Ntypes is +typically specified via the create_box command or in the data file +read by the read_data command. If this keyword is not specified, then +this fix will send the LAMMPS atom type for each atom to the MDI +engine. If both the LAMMPS driver and the MDI engine are initialized +so that atom type values are consistent in both codes, then the +*elements* keyword is not needed. Otherwise the keyword can be used +to insure the two codes are consistent in their definition of atomic +species. + ---------- The following 3 example use cases are illustrated in the examples/mdi diff --git a/doc/src/mdi.rst b/doc/src/mdi.rst index 0d647bbd4e..2591b3ea16 100644 --- a/doc/src/mdi.rst +++ b/doc/src/mdi.rst @@ -14,14 +14,18 @@ Syntax .. parsed-literal:: - *engine* args = none - *plugin* args = name keyword value keyword value + *engine* args = zero or more keyword arg pairs + keywords = *elements* + *elements* args = N_1 N_2 ... N_ntypes + N_1,N_2,...N_ntypes = atomic number for each of ntypes LAMMPS atom types + *plugin* args = name keyword value keyword value ... name = name of plugin library, e.g. lammps means a liblammps.so library will be loaded + keyword/value pairs in any order, some are required, some are optional keywords = *mdi* or *infile* or *extra* or *command* - *mdi* value = args passed to MDI for driver to operate with plugins - *infile* value = filename the engine will read at start-up + *mdi* value = args passed to MDI for driver to operate with plugins (required) + *infile* value = filename the engine will read at start-up (optional) *extra* value = aditional command-line args to pass to engine library when loaded - *command* value = a LAMMPS input script command to execute + *command* value = a LAMMPS input script command to execute (required) *connect* args = none *exit* args = none @@ -31,6 +35,7 @@ Examples .. code-block:: LAMMPS mdi engine + mdi engine elements 13 29 mdi plugin lammps mdi "-role ENGINE -name lammps -method LINK" & infile in.aimd.engine extra "-log log.aimd.engine.plugin" & command "run 5" @@ -109,6 +114,8 @@ commands, which are described further below. - Send/request charge on each atom (N values) * - >COORDS or ELEMENTS + - Send elements (atomic numbers) for each atom (N values) * - FORCES or TOLERANCE - Send 4 tolerance parameters for next MD minimization via OPTG command * - >TYPES or VELOCITIES or COORDS command), then LAMMPS will do a more expensive operation to migrate atoms to new processors as needed and - re-neighbor. If the >NATOMS or >TYPES commands have been sent - (since the previous >COORDS command), then LAMMPS assumes the - system is new and re-initializes an entirely new simulation. + re-neighbor. If the >NATOMS or >TYPES or >ELEMENTS commands have + been sent (since the previous >COORDS command), then LAMMPS assumes + the system is new and re-initializes an entirely new simulation. + +.. note:: + + The >TYPES or >ELEMENTS commands are how the MDI driver tells the + LAMMPS engine which LAMMPS atom type to assign to each atom. If + both the MDI driver and the LAMMPS engine are initialized so that + atom type values are consistent in both codes, then the >TYPES + command can be used. If not, the optional *elements* keyword can + be used to specify what element each LAMMPS atom type corresponds + to. This is specified by the atomic number of the element, e.g. 13 + for Al. An atomic number must be specified for each of the ntypes + LAMMPS atom types. Ntypes is typically specified via the + create_box command or in the data file read by the read_data + command. In this has been done, the MDI driver can send an + >ELEMENTS command to the LAMMPS driver with the atomic number of + each atom. The MD and OPTG commands perform an entire MD simulation or energy minimization (to convergence) with no communication from the driver From 2f1d3205108f9800d4dcefd45004290ca903669b Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Fri, 24 Jun 2022 17:02:12 -0600 Subject: [PATCH 441/585] Cleaned up baseline code, prior to parallelization --- examples/snap/compute_snap_dgrad.py | 147 ++++---- src/ML-SNAP/compute_snap.cpp | 525 ++++++++++++++-------------- 2 files changed, 347 insertions(+), 325 deletions(-) diff --git a/examples/snap/compute_snap_dgrad.py b/examples/snap/compute_snap_dgrad.py index 259e44a504..180734cb0c 100644 --- a/examples/snap/compute_snap_dgrad.py +++ b/examples/snap/compute_snap_dgrad.py @@ -1,8 +1,8 @@ """ compute_snap_dgrad.py Purpose: Demonstrate extraction of descriptor gradient (dB/dR) array from compute snap. - Show that dBi/dRj components summed over neighbors i yields same output as regular compute snap with dgradflag=0. - This shows that the dBi/dRj components extracted with dgradflag=1 are correct. + Show that dBi/dRj components summed over neighbors i yields same output as regular compute snap with dgradflag = 0. + This shows that the dBi/dRj components extracted with dgradflag = 1 are correct. Serial syntax: python compute_snap_dgrad.py Parallel syntax: @@ -22,9 +22,12 @@ me = lmp.extract_setting("world_rank") nprocs = lmp.extract_setting("world_size") cmds = ["-screen", "none", "-log", "none"] -lmp = lammps(cmdargs=cmds) +lmp = lammps(cmdargs = cmds) def run_lammps(dgradflag): + + # simulation settings + lmp.command("clear") lmp.command("units metal") lmp.command("boundary p p p") @@ -35,99 +38,121 @@ def run_lammps(dgradflag): lmp.command(f"create_atoms {ntypes} box") lmp.command("mass * 180.88") lmp.command("displace_atoms all random 0.01 0.01 0.01 123456") - # Pair style - snap_options=f'{rcutfac} {rfac0} {twojmax} {radelem1} {radelem2} {wj1} {wj2} rmin0 {rmin0} quadraticflag {quadratic} bzeroflag {bzero} switchflag {switch} bikflag {bikflag} dgradflag {dgradflag}' + + # potential settings + + snap_options = f'{rcutfac} {rfac0} {twojmax} {radelem1} {radelem2} {wj1} {wj2} rmin0 {rmin0} quadraticflag {quadratic} bzeroflag {bzero} switchflag {switch} bikflag {bikflag} dgradflag {dgradflag}' lmp.command(f"pair_style zero {rcutfac}") lmp.command(f"pair_coeff * *") lmp.command(f"pair_style zbl {zblcutinner} {zblcutouter}") lmp.command(f"pair_coeff * * {zblz} {zblz}") - # set up compute snap generating global array + + # define compute snap + lmp.command(f"compute snap all snap {snap_options}") - # Run + + # run + lmp.command(f"thermo 100") lmp.command(f"run {nsteps}") -# Declare simulation/structure variables -nsteps=0 -nrep=2 -latparam=2.0 -ntypes=2 -nx=nrep -ny=nrep -nz=nrep +# declare simulation/structure variables -# Declare compute snap variables -twojmax=8 -m = (twojmax/2)+1 -rcutfac=1.0 -rfac0=0.99363 -rmin0=0 -radelem1=2.3 -radelem2=2.0 -wj1=1.0 -wj2=0.96 -quadratic=0 -bzero=0 -switch=0 -bikflag=1 -dgradflag=1 +nsteps = 0 +nrep = 2 +latparam = 2.0 +ntypes = 2 +nx = nrep +ny = nrep +nz = nrep -# Declare reference potential variables -zblcutinner=4.0 -zblcutouter=4.8 -zblz=73 +# declare compute snap variables + +twojmax = 8 +rcutfac = 1.0 +rfac0 = 0.99363 +rmin0 = 0 +radelem1 = 2.3 +radelem2 = 2.0 +wj1 = 1.0 +wj2 = 0.96 +quadratic = 0 +bzero = 0 +switch = 0 +bikflag = 1 + +# define reference potential + +zblcutinner = 4.0 +zblcutouter = 4.8 +zblz = 73 + +# number of descriptors -# Number of descriptors if (twojmax % 2 == 0): + m = twojmax / 2 + 1 nd = int(m*(m+1)*(2*m+1)/6) else: + m = (twojmax + 1) / 2 nd = int(m*(m+1)*(m+2)/3) + if me == 0: print(f"Number of descriptors based on twojmax : {nd}") -# Run lammps with dgradflag on +# run lammps with dgradflag on + if me == 0: print("Running with dgradflag on") -run_lammps(1) -# Get global snap array -lmp_snap = lmp.numpy.extract_compute("snap",0, 2) +dgradflag = 1 +run_lammps(dgradflag) + +# get global snap array + +lmp_snap = lmp.numpy.extract_compute("snap", LMP_STYLE_GLOBAL, LMP_TYPE_ARRAY) + +# extract dBj/dRi (includes dBi/dRi) -# Extract dBj/dRi (includes dBi/dRi) natoms = lmp.get_natoms() fref1 = lmp_snap[0:natoms,0:3].flatten() -eref1 = lmp_snap[-1,0] #lmp_snap[-6,0] -dbdr_length = np.shape(lmp_snap)[0]-(natoms) - 1 # Length of neighborlist pruned dbdr array +eref1 = lmp_snap[-1,0] +dbdr_length = np.shape(lmp_snap)[0]-(natoms) - 1 dBdR = lmp_snap[natoms:(natoms+dbdr_length),3:(nd+3)] force_indices = lmp_snap[natoms:(natoms+dbdr_length),0:3].astype(np.int32) -# Sum over neighbors j for each atom i, like dgradflag=0 does. +# sum over atoms i that j is a neighbor of, like dgradflag = 0 does. + array1 = np.zeros((3*natoms,nd)) -a = 0 for k in range(0,nd): for l in range(0,dbdr_length): - j = force_indices[l,0] - i = force_indices[l,1] - array1[3*(i)+a,k] += dBdR[l,k] - a = a+1 - if (a>2): - a=0 + i = force_indices[l,0] + j = force_indices[l,1] + a = force_indices[l,2] + array1[3 * j + a, k] += dBdR[l,k] -# Run lammps with dgradflag off -print("Running with dgradflag off") -run_lammps(0) +# run lammps with dgradflag off -# Get global snap array -lmp_snap = lmp.numpy.extract_compute("snap",0, 2) +if me == 0: + print("Running with dgradflag off") + +dgradflag = 0 +run_lammps(dgradflag) + +# get global snap array + +lmp_snap = lmp.numpy.extract_compute("snap", LMP_STYLE_GLOBAL, LMP_TYPE_ARRAY) natoms = lmp.get_natoms() fref2 = lmp_snap[natoms:(natoms+3*natoms),-1] eref2 = lmp_snap[0,-1] array2 = lmp_snap[natoms:natoms+(3*natoms), nd:-1] -# Sum the arrays obtained from dgradflag on and off. -summ = array1 + array2 -#np.savetxt("sum.dat", summ) +# take difference of arrays obtained from dgradflag on and off. -print(f"Maximum difference in descriptor sums: {np.max(summ)}") -print(f"Maximum difference in reference forces: {np.max(fref1-fref2)}") -print(f"Difference in reference energy: {np.max(eref1-eref2)}") +diffm = array1 - array2 +difff = fref1 - fref2 +diffe = eref1 - eref2 + +if me == 0: + print(f"Max/min difference in dSum(Bi)/dRj: {np.max(diffm)} {np.min(diffm)}") + print(f"Max/min difference in reference forces: {np.max(difff)} {np.min(difff)}") + print(f"Difference in reference energy: {diffe}") diff --git a/src/ML-SNAP/compute_snap.cpp b/src/ML-SNAP/compute_snap.cpp index 8a4ff2249e..52fa685ac2 100644 --- a/src/ML-SNAP/compute_snap.cpp +++ b/src/ML-SNAP/compute_snap.cpp @@ -188,6 +188,9 @@ ComputeSnap::ComputeSnap(LAMMPS *lmp, int narg, char **arg) : if (dgradflag && !bikflag) error->all(FLERR,"Illegal compute snap command: dgradflag=1 requires bikflag=1"); + if (dgradflag && quadraticflag) + error->all(FLERR,"Illegal compute snap command: dgradflag=1 not implemented for quadratic SNAP"); + snaptr = new SNA(lmp, rfac0, twojmax, rmin0, switchflag, bzeroflag, chemflag, bnormflag, wselfallflag, @@ -436,231 +439,152 @@ void ComputeSnap::compute_array() snaptr->compute_duidrj(jj); snaptr->compute_dbidrj(); - // Accumulate dBi/dRi, -dBi/dRj + // accumulate dBi/dRi, -dBi/dRj - double *snadi = snap_peratom[i]+typeoffset_local; - double *snadj = snap_peratom[j]+typeoffset_local; + if (!dgradflag) { - for (int icoeff = 0; icoeff < ncoeff; icoeff++) { + double *snadi = snap_peratom[i]+typeoffset_local; + double *snadj = snap_peratom[j]+typeoffset_local; - snadi[icoeff] += snaptr->dblist[icoeff][0]; - snadi[icoeff+yoffset] += snaptr->dblist[icoeff][1]; - snadi[icoeff+zoffset] += snaptr->dblist[icoeff][2]; + for (int icoeff = 0; icoeff < ncoeff; icoeff++) { - snadj[icoeff] -= snaptr->dblist[icoeff][0]; - snadj[icoeff+yoffset] -= snaptr->dblist[icoeff][1]; - snadj[icoeff+zoffset] -= snaptr->dblist[icoeff][2]; + snadi[icoeff] += snaptr->dblist[icoeff][0]; + snadi[icoeff+yoffset] += snaptr->dblist[icoeff][1]; + snadi[icoeff+zoffset] += snaptr->dblist[icoeff][2]; + snadj[icoeff] -= snaptr->dblist[icoeff][0]; + snadj[icoeff+yoffset] -= snaptr->dblist[icoeff][1]; + snadj[icoeff+zoffset] -= snaptr->dblist[icoeff][2]; + } - if (dgradflag){ - dgrad[dgrad_row_indx+0][icoeff] = snaptr->dblist[icoeff][0]; - dgrad[dgrad_row_indx+1][icoeff] = snaptr->dblist[icoeff][1]; - dgrad[dgrad_row_indx+2][icoeff] = snaptr->dblist[icoeff][2]; - if (icoeff==(ncoeff-1)){ - dgrad[dgrad_row_indx+0][ncoeff] = atom->tag[i]-1; - dgrad[dgrad_row_indx+0][ncoeff+1] = atom->tag[j]-1; - dgrad[dgrad_row_indx+0][ncoeff+2] = 0; - dgrad[dgrad_row_indx+1][ncoeff] = atom->tag[i]-1; - dgrad[dgrad_row_indx+1][ncoeff+1] = atom->tag[j]-1; - dgrad[dgrad_row_indx+1][ncoeff+2] = 1; - dgrad[dgrad_row_indx+2][ncoeff] = atom->tag[i]-1; - dgrad[dgrad_row_indx+2][ncoeff+1] = atom->tag[j]-1; - dgrad[dgrad_row_indx+2][ncoeff+2] = 2; - } - // Accumulate dBi/dRi = sum (-dBi/dRj) for neighbors j of if i - dbiri[3*(atom->tag[i]-1)+0][icoeff] -= snaptr->dblist[icoeff][0]; - dbiri[3*(atom->tag[i]-1)+1][icoeff] -= snaptr->dblist[icoeff][1]; - dbiri[3*(atom->tag[i]-1)+2][icoeff] -= snaptr->dblist[icoeff][2]; - // Get last columns which are i, j, and Cartesian index - if (icoeff==(ncoeff-1)){ - dbiri[3*(atom->tag[i]-1)+0][ncoeff] = atom->tag[i]-1; - dbiri[3*(atom->tag[i]-1)+0][ncoeff+1] = atom->tag[i]-1; - dbiri[3*(atom->tag[i]-1)+0][ncoeff+2] = 0; + if (quadraticflag) { + const int quadraticoffset = ncoeff; + snadi += quadraticoffset; + snadj += quadraticoffset; + int ncount = 0; + for (int icoeff = 0; icoeff < ncoeff; icoeff++) { + double bi = snaptr->blist[icoeff]; + double bix = snaptr->dblist[icoeff][0]; + double biy = snaptr->dblist[icoeff][1]; + double biz = snaptr->dblist[icoeff][2]; + + // diagonal elements of quadratic matrix + + double dbxtmp = bi*bix; + double dbytmp = bi*biy; + double dbztmp = bi*biz; + + snadi[ncount] += dbxtmp; + snadi[ncount+yoffset] += dbytmp; + snadi[ncount+zoffset] += dbztmp; + snadj[ncount] -= dbxtmp; + snadj[ncount+yoffset] -= dbytmp; + snadj[ncount+zoffset] -= dbztmp; - dbiri[3*(atom->tag[i]-1)+1][ncoeff] = atom->tag[i]-1; - dbiri[3*(atom->tag[i]-1)+1][ncoeff+1] = atom->tag[i]-1; - dbiri[3*(atom->tag[i]-1)+1][ncoeff+2] = 1; + ncount++; - dbiri[3*(atom->tag[i]-1)+2][ncoeff] = atom->tag[i]-1; - dbiri[3*(atom->tag[i]-1)+2][ncoeff+1] = atom->tag[i]-1; - dbiri[3*(atom->tag[i]-1)+2][ncoeff+2] = 2; - } - } + // upper-triangular elements of quadratic matrix + + for (int jcoeff = icoeff+1; jcoeff < ncoeff; jcoeff++) { + double dbxtmp = bi*snaptr->dblist[jcoeff][0] + + bix*snaptr->blist[jcoeff]; + double dbytmp = bi*snaptr->dblist[jcoeff][1] + + biy*snaptr->blist[jcoeff]; + double dbztmp = bi*snaptr->dblist[jcoeff][2] + + biz*snaptr->blist[jcoeff]; + + snadi[ncount] += dbxtmp; + snadi[ncount+yoffset] += dbytmp; + snadi[ncount+zoffset] += dbztmp; + snadj[ncount] -= dbxtmp; + snadj[ncount+yoffset] -= dbytmp; + snadj[ncount+zoffset] -= dbztmp; + + ncount++; + } + + } + } + + } else { - } + for (int icoeff = 0; icoeff < ncoeff; icoeff++) { - if (quadraticflag) { - const int quadraticoffset = ncoeff; - snadi += quadraticoffset; - snadj += quadraticoffset; - int ncount = 0; - for (int icoeff = 0; icoeff < ncoeff; icoeff++) { - double bi = snaptr->blist[icoeff]; - double bix = snaptr->dblist[icoeff][0]; - double biy = snaptr->dblist[icoeff][1]; - double biz = snaptr->dblist[icoeff][2]; + // sign convention same as compute snad + + dgrad[dgrad_row_indx+0][icoeff] = -snaptr->dblist[icoeff][0]; + dgrad[dgrad_row_indx+1][icoeff] = -snaptr->dblist[icoeff][1]; + dgrad[dgrad_row_indx+2][icoeff] = -snaptr->dblist[icoeff][2]; - // diagonal elements of quadratic matrix + // accumulate dBi/dRi = sum (-dBi/dRj) for neighbors j of if i - double dbxtmp = bi*bix; - double dbytmp = bi*biy; - double dbztmp = bi*biz; + dbiri[3*(atom->tag[i]-1)+0][icoeff] += snaptr->dblist[icoeff][0]; + dbiri[3*(atom->tag[i]-1)+1][icoeff] += snaptr->dblist[icoeff][1]; + dbiri[3*(atom->tag[i]-1)+2][icoeff] += snaptr->dblist[icoeff][2]; + + } - snadi[ncount] += dbxtmp; - snadi[ncount+yoffset] += dbytmp; - snadi[ncount+zoffset] += dbztmp; - snadj[ncount] -= dbxtmp; - snadj[ncount+yoffset] -= dbytmp; - snadj[ncount+zoffset] -= dbztmp; + dgrad[dgrad_row_indx+0][ncoeff] = atom->tag[i]-1; + dgrad[dgrad_row_indx+0][ncoeff+1] = atom->tag[j]-1; + dgrad[dgrad_row_indx+0][ncoeff+2] = 0; + dgrad[dgrad_row_indx+1][ncoeff] = atom->tag[i]-1; + dgrad[dgrad_row_indx+1][ncoeff+1] = atom->tag[j]-1; + dgrad[dgrad_row_indx+1][ncoeff+2] = 1; + dgrad[dgrad_row_indx+2][ncoeff] = atom->tag[i]-1; + dgrad[dgrad_row_indx+2][ncoeff+1] = atom->tag[j]-1; + dgrad[dgrad_row_indx+2][ncoeff+2] = 2; - ncount++; + dbiri[3*(atom->tag[i]-1)+0][ncoeff] = atom->tag[i]-1; + dbiri[3*(atom->tag[i]-1)+0][ncoeff+1] = atom->tag[i]-1; + dbiri[3*(atom->tag[i]-1)+0][ncoeff+2] = 0; + + dbiri[3*(atom->tag[i]-1)+1][ncoeff] = atom->tag[i]-1; + dbiri[3*(atom->tag[i]-1)+1][ncoeff+1] = atom->tag[i]-1; + dbiri[3*(atom->tag[i]-1)+1][ncoeff+2] = 1; + + dbiri[3*(atom->tag[i]-1)+2][ncoeff] = atom->tag[i]-1; + dbiri[3*(atom->tag[i]-1)+2][ncoeff+1] = atom->tag[i]-1; + dbiri[3*(atom->tag[i]-1)+2][ncoeff+2] = 2; - // upper-triangular elements of quadratic matrix - - for (int jcoeff = icoeff+1; jcoeff < ncoeff; jcoeff++) { - double dbxtmp = bi*snaptr->dblist[jcoeff][0] - + bix*snaptr->blist[jcoeff]; - double dbytmp = bi*snaptr->dblist[jcoeff][1] - + biy*snaptr->blist[jcoeff]; - double dbztmp = bi*snaptr->dblist[jcoeff][2] - + biz*snaptr->blist[jcoeff]; - - snadi[ncount] += dbxtmp; - snadi[ncount+yoffset] += dbytmp; - snadi[ncount+zoffset] += dbztmp; - snadj[ncount] -= dbxtmp; - snadj[ncount+yoffset] -= dbytmp; - snadj[ncount+zoffset] -= dbztmp; - - ncount++; - } - } - - } + } } - // linear contributions + // accumulate Bi + + if (!dgradflag) { - int k; - if (dgradflag){ - k = 0; - for (int icoeff = 0; icoeff < ncoeff; icoeff++){ - snap[irow][k+3] += snaptr->blist[icoeff]; - k = k+1; - } - } - else{ - k = typeoffset_global; - for (int icoeff = 0; icoeff < ncoeff; icoeff++){ + // linear contributions + + int k = typeoffset_global; + for (int icoeff = 0; icoeff < ncoeff; icoeff++) snap[irow][k++] += snaptr->blist[icoeff]; - } - } - // quadratic contributions + // quadratic contributions - if (quadraticflag) { - for (int icoeff = 0; icoeff < ncoeff; icoeff++) { - double bveci = snaptr->blist[icoeff]; - snap[irow][k++] += 0.5*bveci*bveci; - for (int jcoeff = icoeff+1; jcoeff < ncoeff; jcoeff++) { - double bvecj = snaptr->blist[jcoeff]; - snap[irow][k++] += bveci*bvecj; - } - } + if (quadraticflag) { + for (int icoeff = 0; icoeff < ncoeff; icoeff++) { + double bveci = snaptr->blist[icoeff]; + snap[irow][k++] += 0.5*bveci*bveci; + for (int jcoeff = icoeff+1; jcoeff < ncoeff; jcoeff++) { + double bvecj = snaptr->blist[jcoeff]; + snap[irow][k++] += bveci*bvecj; + } + } + } + + } else { + int k = 3; + for (int icoeff = 0; icoeff < ncoeff; icoeff++) + snap[irow][k++] += snaptr->blist[icoeff]; + numneigh_sum += ninside; } } - - numneigh_sum += ninside; - } // for (int ii = 0; ii < inum; ii++) - - // Accumulate contributions to global array - - if (dgradflag){ - - int dbiri_indx; - int irow; - for (int itype=0; itype<1; itype++){ - const int typeoffset_local = ndims_peratom*nperdim*itype; - const int typeoffset_global = nperdim*itype; - for (int icoeff = 0; icoeff < nperdim; icoeff++) { - dbiri_indx=0; - for (int i = 0; i < atom->nlocal; i++) { - - for (int jj=0; jjtag[i]-1] + 3*jj; - int snap_row_indx = 3*neighsum[atom->tag[i]-1] + 3*(atom->tag[i]-1) + 3*jj; - irow = snap_row_indx + bik_rows; - - // x-coordinate - snap[irow][icoeff+3] += dgrad[dgrad_row_indx+0][icoeff]; - if (icoeff==(ncoeff-1)){ - snap[irow][0] += dgrad[dgrad_row_indx+0][ncoeff]; - snap[irow][0+1] += dgrad[dgrad_row_indx+0][ncoeff+1]; - snap[irow][0+2] += dgrad[dgrad_row_indx+0][ncoeff+2]; - } - irow++; - - // y-coordinate - snap[irow][icoeff+3] += dgrad[dgrad_row_indx+1][icoeff]; - if (icoeff==(ncoeff-1)){ - snap[irow][0] += dgrad[dgrad_row_indx+1][ncoeff]; - snap[irow][0+1] += dgrad[dgrad_row_indx+1][ncoeff+1]; - snap[irow][0+2] += dgrad[dgrad_row_indx+1][ncoeff+2]; - } - irow++; - - // z-coordinate - snap[irow][icoeff+3] += dgrad[dgrad_row_indx+2][icoeff]; - if (icoeff==(ncoeff-1)){ - snap[irow][0] += dgrad[dgrad_row_indx+2][ncoeff]; - snap[irow][0+1] += dgrad[dgrad_row_indx+2][ncoeff+1]; - snap[irow][0+2] += dgrad[dgrad_row_indx+2][ncoeff+2]; - } - dbiri_indx = dbiri_indx+3; - } - - // Put dBi/dRi at end of each dBj/dRi chunk. - - irow = dbiri_indx + bik_rows; - - // x-coordinate - snap[irow][icoeff+3] += dbiri[3*i+0][icoeff]; - if (icoeff==(ncoeff-1)){ - snap[irow][0] += dbiri[3*i+0][ncoeff]; - snap[irow][0+1] += dbiri[3*i+0][ncoeff+1]; - snap[irow][0+2] += dbiri[3*i+0][ncoeff+2]; - } - irow++; - - // y-coordinate - snap[irow][icoeff+3] += dbiri[3*i+1][icoeff]; - if (icoeff==(ncoeff-1)){ - snap[irow][0] += dbiri[3*i+1][ncoeff]; - snap[irow][0+1] += dbiri[3*i+1][ncoeff+1]; - snap[irow][0+2] += dbiri[3*i+1][ncoeff+2]; - } - irow++; - - // z-coordinate - snap[irow][icoeff+3] += dbiri[3*i+2][icoeff]; - if (icoeff==(ncoeff-1)){ - snap[irow][0] += dbiri[3*i+2][ncoeff]; - snap[irow][0+1] += dbiri[3*i+2][ncoeff+1]; - snap[irow][0+2] += dbiri[3*i+2][ncoeff+2]; - } - - dbiri_indx = dbiri_indx+3; - } - } - } - } - else{ + // accumulate bispectrum force contributions to global array - // accumulate bispectrum force contributions to global array + if (!dgradflag) { for (int itype = 0; itype < atom->ntypes; itype++) { const int typeoffset_local = ndims_peratom*nperdim*itype; @@ -676,21 +600,81 @@ void ComputeSnap::compute_array() } } } + + } else { + + int irow = bik_rows; + for (int itype = 0; itype < 1; itype++) { + const int typeoffset_local = ndims_peratom * nperdim * itype; + const int typeoffset_global = nperdim * itype; + for (int i = 0; i < atom->nlocal; i++) { + + for (int jj = 0; jjtag[i]-1] + 3 * jj; + int snap_row_indx = 3 * neighsum[atom->tag[i]-1] + 3 * (atom->tag[i]-1) + 3 * jj; + // irow = snap_row_indx + bik_rows; + + // x-coordinate + for (int icoeff = 0; icoeff < nperdim; icoeff++) + snap[irow][icoeff+3] += dgrad[dgrad_row_indx+0][icoeff]; + snap[irow][0] += dgrad[dgrad_row_indx+0][ncoeff]; + snap[irow][0+1] += dgrad[dgrad_row_indx+0][ncoeff+1]; + snap[irow][0+2] += dgrad[dgrad_row_indx+0][ncoeff+2]; + irow++; + + // y-coordinate + for (int icoeff = 0; icoeff < nperdim; icoeff++) + snap[irow][icoeff+3] += dgrad[dgrad_row_indx+1][icoeff]; + snap[irow][0] += dgrad[dgrad_row_indx+1][ncoeff]; + snap[irow][0+1] += dgrad[dgrad_row_indx+1][ncoeff+1]; + snap[irow][0+2] += dgrad[dgrad_row_indx+1][ncoeff+2]; + irow++; + + // z-coordinate + for (int icoeff = 0; icoeff < nperdim; icoeff++) + snap[irow][icoeff+3] += dgrad[dgrad_row_indx+2][icoeff]; + snap[irow][0] += dgrad[dgrad_row_indx+2][ncoeff]; + snap[irow][0+1] += dgrad[dgrad_row_indx+2][ncoeff+1]; + snap[irow][0+2] += dgrad[dgrad_row_indx+2][ncoeff+2]; + irow++; + + } + + // Put dBi/dRi at end of each dBj/dRi chunk. + + // x-coordinate + for (int icoeff = 0; icoeff < nperdim; icoeff++) + snap[irow][icoeff+3] += dbiri[3*i+0][icoeff]; + snap[irow][0] += dbiri[3*i+0][ncoeff]; + snap[irow][0+1] += dbiri[3*i+0][ncoeff+1]; + snap[irow][0+2] += dbiri[3*i+0][ncoeff+2]; + irow++; + + // y-coordinate + for (int icoeff = 0; icoeff < nperdim; icoeff++) + snap[irow][icoeff+3] += dbiri[3*i+1][icoeff]; + snap[irow][0] += dbiri[3*i+1][ncoeff]; + snap[irow][0+1] += dbiri[3*i+1][ncoeff+1]; + snap[irow][0+2] += dbiri[3*i+1][ncoeff+2]; + irow++; + + // z-coordinate + for (int icoeff = 0; icoeff < nperdim; icoeff++) + snap[irow][icoeff+3] += dbiri[3*i+2][icoeff]; + snap[irow][0] += dbiri[3*i+2][ncoeff]; + snap[irow][0+1] += dbiri[3*i+2][ncoeff+1]; + snap[irow][0+2] += dbiri[3*i+2][ncoeff+2]; + irow++; + + } + } + } // accumulate forces to global array - if (dgradflag){ - // for dgradflag=1, put forces at first 3 columns of bik rows - for (int i=0; inlocal; i++){ - int iglobal = atom->tag[i]; - snap[iglobal-1][0+0] = atom->f[i][0]; - snap[iglobal-1][0+1] = atom->f[i][1]; - snap[iglobal-1][0+2] = atom->f[i][2]; - - } - } - else{ + if (!dgradflag) { for (int i = 0; i < atom->nlocal; i++) { int iglobal = atom->tag[i]; int irow = 3*(iglobal-1)+bik_rows; @@ -698,42 +682,50 @@ void ComputeSnap::compute_array() snap[irow++][lastcol] = atom->f[i][1]; snap[irow][lastcol] = atom->f[i][2]; } + + } else { + + // for dgradflag=1, put forces at first 3 columns of bik rows + + for (int i=0; inlocal; i++){ + int iglobal = atom->tag[i]; + snap[iglobal-1][0+0] = atom->f[i][0]; + snap[iglobal-1][0+1] = atom->f[i][1]; + snap[iglobal-1][0+2] = atom->f[i][2]; + } } // accumulate bispectrum virial contributions to global array - if (dgradflag){ - // no virial terms for dgrad yet - } - else{ - dbdotr_compute(); - } + dbdotr_compute(); // sum up over all processes + MPI_Allreduce(&snap[0][0],&snapall[0][0],size_array_rows*size_array_cols,MPI_DOUBLE,MPI_SUM,world); + // assign energy to last column - if (dgradflag){ + + if (!dgradflag) { + for (int i = 0; i < bik_rows; i++) snapall[i][lastcol] = 0; + int irow = 0; + double reference_energy = c_pe->compute_scalar(); + snapall[irow][lastcol] = reference_energy; + + } else { + // Assign reference energy right after the dgrad rows, first column. // Add 3N for the dBi/dRi rows. int irow = bik_rows + dgrad_rows + 3*natoms; double reference_energy = c_pe->compute_scalar(); snapall[irow][0] = reference_energy; } - else{ - for (int i = 0; i < bik_rows; i++) snapall[i][lastcol] = 0; - int irow = 0; - double reference_energy = c_pe->compute_scalar(); - snapall[irow][lastcol] = reference_energy; - } // assign virial stress to last column // switch to Voigt notation c_virial->compute_vector(); - if (dgradflag){ + if (!dgradflag) { // no virial terms for dgrad yet - } - else{ c_virial->compute_vector(); int irow = 3*natoms+bik_rows; snapall[irow++][lastcol] = c_virial->vector[0]; @@ -743,7 +735,7 @@ void ComputeSnap::compute_array() snapall[irow++][lastcol] = c_virial->vector[4]; snapall[irow][lastcol] = c_virial->vector[3]; } - + } /* ---------------------------------------------------------------------- @@ -753,6 +745,11 @@ void ComputeSnap::compute_array() void ComputeSnap::dbdotr_compute() { + + // no virial terms for dgrad yet + + if (dgradflag) return; + double **x = atom->x; int irow0 = bik_rows+ndims_force*natoms; @@ -792,7 +789,9 @@ void ComputeSnap::get_dgrad_length() memory->destroy(snap); memory->destroy(snapall); + // invoke full neighbor list + neighbor->build_one(list); dgrad_rows = 0; const int inum = list->inum; @@ -807,19 +806,17 @@ void ComputeSnap::get_dgrad_length() memory->create(nneighs, natoms, "snap:nneighs"); memory->create(icounter, natoms, "snap:icounter"); memory->create(dbiri, 3*natoms,ncoeff+3, "snap:dbiri"); - if (atom->nlocal != natoms){ + if (atom->nlocal != natoms) error->all(FLERR,"Compute snap dgradflag=1 does not support parallelism yet."); - } - for (int ii=0; ii<3*natoms; ii++){ - for (int icoeff=0; icoeff1e-20) { - dgrad_rows += 1; //jnum + 1; - jnum_cutoff += 1; - nneighs[i]+=1; + if (rsq < cutsq[itype][jtype] && rsq>1e-20) { + dgrad_rows++; + nneighs[i]++; } } } @@ -849,31 +844,33 @@ void ComputeSnap::get_dgrad_length() dgrad_rows *= ndims_force; - // Loop over all atoms again to calculate neighsum. - for (int ii = 0; ii < inum; ii++) { - const int i = ilist[ii]; - if (mask[i] & groupbit) { - if (i==0){ - neighsum[i]=0; - } - else{ - for (int jj=0; jj < ii; jj++){ - const int j = ilist[jj]; - if (mask[j] & groupbit) { - neighsum[i] += nneighs[j]; - } - } - } - } - } + // loop over all atoms again to calculate neighsum - memory->create(dgrad, dgrad_rows, ncoeff+3, "snap:dgrad"); - for (int i=0; icreate(dgrad, dgrad_rows, ncoeff+3, "snap:dgrad"); + for (int i = 0; i < dgrad_rows; i++) + for (int j = 0; j < ncoeff+3; j++) + dgrad[i][j] = 0.0; + + // set size array rows which now depends on dgrad_rows. + size_array_rows = bik_rows + dgrad_rows + 3*atom->nlocal + 1; // Add 3*N for dBi/dRi. and add 1 for reference energy memory->create(snap,size_array_rows,size_array_cols, "snap:snap"); From 5023103dfb0dccd15b6745f32f876dbe4e8d55bf Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Fri, 24 Jun 2022 17:42:51 -0600 Subject: [PATCH 442/585] Added placeholder get_dgrad_length2() --- src/ML-SNAP/compute_snap.cpp | 131 ++++++++++++++++++++++++++--------- src/ML-SNAP/compute_snap.h | 2 +- 2 files changed, 99 insertions(+), 34 deletions(-) diff --git a/src/ML-SNAP/compute_snap.cpp b/src/ML-SNAP/compute_snap.cpp index 52fa685ac2..eb404d70a4 100644 --- a/src/ML-SNAP/compute_snap.cpp +++ b/src/ML-SNAP/compute_snap.cpp @@ -202,18 +202,18 @@ ComputeSnap::ComputeSnap(LAMMPS *lmp, int narg, char **arg) : ndims_force = 3; ndims_virial = 6; yoffset = nperdim; - zoffset = 2*nperdim; + zoffset = 2 * nperdim; natoms = atom->natoms; bik_rows = 1; if (bikflag) bik_rows = natoms; dgrad_rows = ndims_force*natoms; - size_array_rows = bik_rows+dgrad_rows+ndims_virial; - if (dgradflag) size_array_cols = nperdim+3; // plus 3 for tag[i], tag[j], and cartesian index - else size_array_cols = nperdim*atom->ntypes+1; + size_array_rows = bik_rows+dgrad_rows + ndims_virial; + if (dgradflag) size_array_cols = nperdim + 3; + else size_array_cols = nperdim*atom->ntypes + 1; lastcol = size_array_cols-1; ndims_peratom = ndims_force; - size_peratom = ndims_peratom*nperdim*atom->ntypes; + size_peratom = ndims_peratom * nperdim * atom->ntypes; nmax = 0; } @@ -266,19 +266,10 @@ void ComputeSnap::init() // allocate memory for global array - if (dgradflag){ - // Initially allocate natoms^2 rows, will prune with neighborlist later - memory->create(snap,natoms*natoms,ncoeff+3, - "snap:snap"); - memory->create(snapall,natoms*natoms,ncoeff+3, - "snap:snapall"); - } - else{ - memory->create(snap,size_array_rows,size_array_cols, - "snap:snap"); - memory->create(snapall,size_array_rows,size_array_cols, - "snap:snapall"); - } + memory->create(snap,size_array_rows,size_array_cols, + "snap:snap"); + memory->create(snapall,size_array_rows,size_array_cols, + "snap:snapall"); array = snapall; // find compute for reference energy @@ -290,6 +281,7 @@ void ComputeSnap::init() c_pe = modify->compute[ipe]; // add compute for reference virial tensor + std::string id_virial = std::string("snap_press"); std::string pcmd = id_virial + " all pressure NULL virial"; modify->add_compute(pcmd); @@ -314,9 +306,8 @@ void ComputeSnap::init_list(int /*id*/, NeighList *ptr) void ComputeSnap::compute_array() { - if (dgradflag){ - get_dgrad_length(); - } + if (dgradflag) get_dgrad_length(); + // if (dgradflag) get_dgrad_length2(); int ntotal = atom->nlocal + atom->nghost; @@ -345,6 +336,7 @@ void ComputeSnap::compute_array() } // invoke full neighbor list (will copy or build if necessary) + neighbor->build_one(list); const int inum = list->inum; @@ -723,9 +715,7 @@ void ComputeSnap::compute_array() // assign virial stress to last column // switch to Voigt notation - c_virial->compute_vector(); if (!dgradflag) { - // no virial terms for dgrad yet c_virial->compute_vector(); int irow = 3*natoms+bik_rows; snapall[irow++][lastcol] = c_virial->vector[0]; @@ -844,6 +834,91 @@ void ComputeSnap::get_dgrad_length() dgrad_rows *= ndims_force; + neighsum[0] = 0; + for (int ii = 1; ii < inum; ii++) { + const int i = ilist[ii]; + if (mask[i] & groupbit) + neighsum[i] = neighsum[i-1] + nneighs[i-1]; + } + + memory->create(dgrad, dgrad_rows, ncoeff+3, "snap:dgrad"); + for (int i = 0; i < dgrad_rows; i++) + for (int j = 0; j < ncoeff+3; j++) + dgrad[i][j] = 0.0; + + // set size array rows which now depends on dgrad_rows. + + size_array_rows = bik_rows + dgrad_rows + 3*atom->nlocal + 1; // Add 3*N for dBi/dRi. and add 1 for reference energy + + memory->create(snap,size_array_rows,size_array_cols, "snap:snap"); + memory->create(snapall,size_array_rows,size_array_cols, "snap:snapall"); + array = snapall; + +} + +/* ---------------------------------------------------------------------- + compute dgrad length +------------------------------------------------------------------------- */ + +void ComputeSnap::get_dgrad_length2() +{ + memory->destroy(snap); + memory->destroy(snapall); + + // invoke full neighbor list + + neighbor->build_one(list); + dgrad_rows = 0; + const int inum = list->inum; + const int* const ilist = list->ilist; + const int* const numneigh = list->numneigh; + int** const firstneigh = list->firstneigh; + int * const type = atom->type; + const int* const mask = atom->mask; + double** const x = atom->x; + + memory->create(neighsum, natoms, "snap:neighsum"); + memory->create(nneighs, natoms, "snap:nneighs"); + memory->create(icounter, natoms, "snap:icounter"); + memory->create(dbiri, 3*natoms,ncoeff+3, "snap:dbiri"); + if (atom->nlocal != natoms) + error->all(FLERR,"Compute snap dgradflag=1 does not support parallelism yet."); + + for (int ii = 0; ii < 3 * natoms; ii++) + for (int icoeff = 0; icoeff < ncoeff; icoeff++) + dbiri[ii][icoeff] = 0.0; + + for (int ii = 0; ii < inum; ii++) { + const int i = ilist[ii]; + if (mask[i] & groupbit) { + icounter[i] = 0; + nneighs[i] = 0; + const double xtmp = x[i][0]; + const double ytmp = x[i][1]; + const double ztmp = x[i][2]; + const int itype = type[i]; + const int* const jlist = firstneigh[i]; + const int jnum = numneigh[i]; + for (int jj = 0; jj < jnum; jj++) { + int j = jlist[jj]; + j &= NEIGHMASK; + + const double delx = x[j][0] - xtmp; + const double dely = x[j][1] - ytmp; + const double delz = x[j][2] - ztmp; + const double rsq = delx * delx + dely * dely + delz * delz; + int jtype = type[j]; + + if (rsq < cutsq[itype][jtype] && rsq>1e-20) { + dgrad_rows++; + nneighs[i]++; + } + } + } + } + + dgrad_rows *= ndims_force; + // loop over all atoms again to calculate neighsum // for (int ii = 0; ii < inum; ii++) { @@ -879,16 +954,6 @@ void ComputeSnap::get_dgrad_length() } -/* ---------------------------------------------------------------------- - compute array length -------------------------------------------------------------------------- */ - -double ComputeSnap::compute_scalar() -{ - if (dgradflag) get_dgrad_length(); - return size_array_rows; -} - /* ---------------------------------------------------------------------- memory usage ------------------------------------------------------------------------- */ diff --git a/src/ML-SNAP/compute_snap.h b/src/ML-SNAP/compute_snap.h index dcdf339b72..f106421635 100644 --- a/src/ML-SNAP/compute_snap.h +++ b/src/ML-SNAP/compute_snap.h @@ -31,7 +31,6 @@ class ComputeSnap : public Compute { void init() override; void init_list(int, class NeighList *) override; void compute_array() override; - double compute_scalar() override; double memory_usage() override; private: @@ -66,6 +65,7 @@ class ComputeSnap : public Compute { void dbdotr_compute(); void get_dgrad_length(); + void get_dgrad_length2(); }; } // namespace LAMMPS_NS From 74d1d391b52b90eccfb8b8c010af9e8146556490 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Fri, 24 Jun 2022 18:14:07 -0600 Subject: [PATCH 443/585] fix comm issue with fix bitorsion --- src/AMOEBA/fix_amoeba_bitorsion.cpp | 51 +++++++++++++++++++++++++++++ src/AMOEBA/fix_amoeba_bitorsion.h | 4 ++- 2 files changed, 54 insertions(+), 1 deletion(-) diff --git a/src/AMOEBA/fix_amoeba_bitorsion.cpp b/src/AMOEBA/fix_amoeba_bitorsion.cpp index 53f36353f0..85a87b0452 100644 --- a/src/AMOEBA/fix_amoeba_bitorsion.cpp +++ b/src/AMOEBA/fix_amoeba_bitorsion.cpp @@ -91,6 +91,13 @@ FixAmoebaBiTorsion::FixAmoebaBiTorsion(LAMMPS *lmp, int narg, char **arg) : read_grid_data(arg[3]); create_splines(); + // border comm of 1st neighbors in special list + // so chkttor() can use them when central atom = ghost to check chirality + // comm_border = max # of bonds per atom + 1 for count + + comm_border = 7; + atom->add_callback(Atom::BORDER); + // perform initial allocation of atom-based arrays num_bitorsion = nullptr; @@ -1745,6 +1752,50 @@ void FixAmoebaBiTorsion::set_arrays(int i) num_bitorsion[i] = 0; } +/* ---------------------------------------------------------------------- + pack values for border communication at re-neighboring +------------------------------------------------------------------------- */ + +int FixAmoebaBiTorsion::pack_border(int n, int *list, double *buf) +{ + int i, j, k; + + int **nspecial = atom->nspecial; + tagint **special = atom->special; + + int m = 0; + for (i = 0; i < n; i++) { + j = list[i]; + buf[m++] = ubuf(nspecial[j][0]).d; + for (k = 0; k < nspecial[j][0]; k++) + buf[m++] = ubuf(special[j][k]).d; + } + + return m; +} + +/* ---------------------------------------------------------------------- + unpack values for border communication at re-neighboring +------------------------------------------------------------------------- */ + +int FixAmoebaBiTorsion::unpack_border(int n, int first, double *buf) +{ + int i, k, last; + + int **nspecial = atom->nspecial; + tagint **special = atom->special; + + int m = 0; + last = first + n; + for (i = first; i < last; i++) { + nspecial[i][0] = (int) ubuf(buf[m++]).i; + for (k = 0; k < nspecial[i][0]; k++) + special[i][k] = (tagint) ubuf(buf[m++]).i; + } + + return m; +} + /* ---------------------------------------------------------------------- pack values in local atom-based array for exchange with another proc ------------------------------------------------------------------------- */ diff --git a/src/AMOEBA/fix_amoeba_bitorsion.h b/src/AMOEBA/fix_amoeba_bitorsion.h index c46f0c45dc..6c5afd5274 100644 --- a/src/AMOEBA/fix_amoeba_bitorsion.h +++ b/src/AMOEBA/fix_amoeba_bitorsion.h @@ -59,6 +59,8 @@ class FixAmoebaBiTorsion : public Fix { void grow_arrays(int); void copy_arrays(int, int, int); void set_arrays(int); + int pack_border(int, int *, double *) override; + int unpack_border(int, int, double *) override; int pack_exchange(int, double *); int unpack_exchange(int, double *); @@ -69,7 +71,7 @@ class FixAmoebaBiTorsion : public Fix { int eflag_caller; int ilevel_respa; int disable; - bigint nbitorsions; + bigint nbitorsions; // total count of all bitorsions in system double ebitorsion; double onefifth; From 4de3f7ed6979b44f078ee38651cde3aa3e52914e Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sat, 25 Jun 2022 06:15:49 -0400 Subject: [PATCH 444/585] intergrate references to dump cfg/uef into the dump command docs --- doc/src/dump.rst | 44 ++++++++++++++++++++++++-------------------- 1 file changed, 24 insertions(+), 20 deletions(-) diff --git a/doc/src/dump.rst b/doc/src/dump.rst index 4d272c940b..4417e186ec 100644 --- a/doc/src/dump.rst +++ b/doc/src/dump.rst @@ -27,6 +27,9 @@ dump command :doc:`dump custom/adios ` command ============================================= +:doc:`dump cfg/uef ` command +========================================== + Syntax """""" @@ -36,7 +39,7 @@ Syntax * ID = user-assigned name for the dump * group-ID = ID of the group of atoms to be dumped -* style = *atom* or *atom/gz* or *atom/zstd or *atom/mpiio* or *cfg* or *cfg/gz* or *cfg/zstd* or *cfg/mpiio* or *custom* or *custom/gz* or *custom/zstd* or *custom/mpiio* or *dcd* or *h5md* or *image* or *local* or *local/gz* or *local/zstd* or *molfile* or *movie* or *netcdf* or *netcdf/mpiio* or *vtk* or *xtc* or *xyz* or *xyz/gz* or *xyz/zstd* or *xyz/mpiio* or *yaml* +* style = *atom* or *atom/gz* or *atom/zstd or *atom/mpiio* or *cfg* or *cfg/gz* or *cfg/zstd* or *cfg/mpiio* or *cfg/uef* or *custom* or *custom/gz* or *custom/zstd* or *custom/mpiio* or *dcd* or *h5md* or *image* or *local* or *local/gz* or *local/zstd* or *molfile* or *movie* or *netcdf* or *netcdf/mpiio* or *vtk* or *xtc* or *xyz* or *xyz/gz* or *xyz/zstd* or *xyz/mpiio* or *yaml* * N = dump every this many timesteps * file = name of file to write dump info to * args = list of arguments for a particular style @@ -47,22 +50,23 @@ Syntax *atom/gz* args = none *atom/zstd* args = none *atom/mpiio* args = none - *atom/adios* args = none, discussed on :doc:`dump atom/adios ` doc page + *atom/adios* args = none, discussed on :doc:`dump atom/adios ` page *cfg* args = same as *custom* args, see below *cfg/gz* args = same as *custom* args, see below *cfg/zstd* args = same as *custom* args, see below *cfg/mpiio* args = same as *custom* args, see below + *cfg/uef* args = same as *custom* args, discussed on :doc:`dump cfg/uef ` page *custom*, *custom/gz*, *custom/zstd*, *custom/mpiio* args = see below - *custom/adios* args = same as *custom* args, discussed on :doc:`dump custom/adios ` doc page + *custom/adios* args = same as *custom* args, discussed on :doc:`dump custom/adios ` page *dcd* args = none - *h5md* args = discussed on :doc:`dump h5md ` doc page - *image* args = discussed on :doc:`dump image ` doc page + *h5md* args = discussed on :doc:`dump h5md ` page + *image* args = discussed on :doc:`dump image ` page *local*, *local/gz*, *local/zstd* args = see below - *molfile* args = discussed on :doc:`dump molfile ` doc page - *movie* args = discussed on :doc:`dump image ` doc page - *netcdf* args = discussed on :doc:`dump netcdf ` doc page - *netcdf/mpiio* args = discussed on :doc:`dump netcdf ` doc page - *vtk* args = same as *custom* args, see below, also :doc:`dump vtk ` doc page + *molfile* args = discussed on :doc:`dump molfile ` page + *movie* args = discussed on :doc:`dump image ` page + *netcdf* args = discussed on :doc:`dump netcdf ` page + *netcdf/mpiio* args = discussed on :doc:`dump netcdf ` page + *vtk* args = same as *custom* args, see below, also :doc:`dump vtk ` page *xtc* args = none *xyz* args = none *xyz/gz* args = none @@ -155,7 +159,7 @@ timesteps in one of several styles. The *image* and *movie* styles are the exception: the *image* style renders a JPG, PNG, or PPM image file of the atom configuration every N timesteps while the *movie* style combines and compresses them into a movie file; both are discussed in -detail on the :doc:`dump image ` doc page. The timesteps on +detail on the :doc:`dump image ` page. The timesteps on which dump output is written can also be controlled by a variable. See the :doc:`dump_modify every ` command. @@ -194,7 +198,7 @@ or multiple smaller files). For the *atom*, *custom*, *cfg*, and *local* styles, sorting is off by default. For the *dcd*, *xtc*, *xyz*, and *molfile* styles, sorting by atom ID is on by default. See the :doc:`dump_modify ` -doc page for details. +page for details. The *atom/gz*, *cfg/gz*, *custom/gz*, *local/gz*, and *xyz/gz* styles are identical in command syntax to the corresponding styles without @@ -204,7 +208,7 @@ alternative approach to writing compressed files via a pipe, as done by the regular dump styles, which may be required on clusters where the interface to the high-speed network disallows using the fork() library call (which is needed for a pipe). For the remainder of this -doc page, you should thus consider the *atom* and *atom/gz* styles +page, you should thus consider the *atom* and *atom/gz* styles (etc) to be inter-changeable, with the exception of the required filename suffix. @@ -218,7 +222,7 @@ As explained below, the *atom/mpiio*, *cfg/mpiio*, *custom/mpiio*, and *xyz/mpiio* styles are identical in command syntax and in the format of the dump files they create, to the corresponding styles without "mpiio", except the single dump file they produce is written in -parallel via the MPI-IO library. For the remainder of this doc page, +parallel via the MPI-IO library. For the remainder of this page, you should thus consider the *atom* and *atom/mpiio* styles (etc) to be inter-changeable. The one exception is how the filename is specified for the MPI-IO styles, as explained below. @@ -664,7 +668,7 @@ so that each value is 0.0 to 1.0. If the simulation box is triclinic (tilted), then all atom coords will still be between 0.0 and 1.0. I.e. actual unscaled (x,y,z) = xs\*A + ys\*B + zs\*C, where (A,B,C) are the non-orthogonal vectors of the simulation box edges, as discussed -on the :doc:`Howto triclinic ` doc page. +on the :doc:`Howto triclinic ` page. Use *xu*, *yu*, *zu* if you want the coordinates "unwrapped" by the image flags for each atom. Unwrapped means that if the atom has @@ -787,7 +791,7 @@ more info. The *atom/mpiio*, *cfg/mpiio*, *custom/mpiio*, and *xyz/mpiio* styles are part of the MPIIO package. They are only enabled if LAMMPS was built with that package. See the :doc:`Build package ` -doc page for more info. +page for more info. The *xtc*, *dcd* and *yaml* styles are part of the EXTRA-DUMP package. They are only enabled if LAMMPS was built with that package. See the @@ -797,12 +801,12 @@ Related commands """""""""""""""" :doc:`dump atom/adios `, :doc:`dump custom/adios `, -:doc:`dump h5md `, :doc:`dump image `, -:doc:`dump molfile `, :doc:`dump_modify `, -:doc:`undump ` +:doc:`dump cfg/uef `, :doc:`dump h5md `, +:doc:`dump image `, :doc:`dump molfile `, +:doc:`dump_modify `, :doc:`undump `, :doc:`write_dump ` Default """"""" The defaults for the *image* and *movie* styles are listed on the -:doc:`dump image ` doc page. +:doc:`dump image ` page. From a8ba6db9610cfb492d4187d2ad4a672867790398 Mon Sep 17 00:00:00 2001 From: jkelowitt <58435724+jkelowitt@users.noreply.github.com> Date: Mon, 27 Jun 2022 17:02:39 -0600 Subject: [PATCH 445/585] Make the threebody loop optional --- src/MANYBODY/pair_sw.cpp | 108 +++++++++++++++++++++++---------------- src/MANYBODY/pair_sw.h | 1 + 2 files changed, 64 insertions(+), 45 deletions(-) diff --git a/src/MANYBODY/pair_sw.cpp b/src/MANYBODY/pair_sw.cpp index 71cb1cf5bc..9188b98ae9 100644 --- a/src/MANYBODY/pair_sw.cpp +++ b/src/MANYBODY/pair_sw.cpp @@ -159,50 +159,51 @@ void PairSW::compute(int eflag, int vflag) if (evflag) ev_tally(i,j,nlocal,newton_pair, evdwl,0.0,fpair,delx,dely,delz); } - - jnumm1 = numshort - 1; - - for (jj = 0; jj < jnumm1; jj++) { - j = neighshort[jj]; - jtype = map[type[j]]; - ijparam = elem3param[itype][jtype][jtype]; - delr1[0] = x[j][0] - xtmp; - delr1[1] = x[j][1] - ytmp; - delr1[2] = x[j][2] - ztmp; - rsq1 = delr1[0]*delr1[0] + delr1[1]*delr1[1] + delr1[2]*delr1[2]; - - double fjxtmp,fjytmp,fjztmp; - fjxtmp = fjytmp = fjztmp = 0.0; - - for (kk = jj+1; kk < numshort; kk++) { - k = neighshort[kk]; - ktype = map[type[k]]; - ikparam = elem3param[itype][ktype][ktype]; - ijkparam = elem3param[itype][jtype][ktype]; - - delr2[0] = x[k][0] - xtmp; - delr2[1] = x[k][1] - ytmp; - delr2[2] = x[k][2] - ztmp; - rsq2 = delr2[0]*delr2[0] + delr2[1]*delr2[1] + delr2[2]*delr2[2]; - - threebody(¶ms[ijparam],¶ms[ikparam],¶ms[ijkparam], - rsq1,rsq2,delr1,delr2,fj,fk,eflag,evdwl); - - fxtmp -= fj[0] + fk[0]; - fytmp -= fj[1] + fk[1]; - fztmp -= fj[2] + fk[2]; - fjxtmp += fj[0]; - fjytmp += fj[1]; - fjztmp += fj[2]; - f[k][0] += fk[0]; - f[k][1] += fk[1]; - f[k][2] += fk[2]; - - if (evflag) ev_tally3(i,j,k,evdwl,0.0,fj,fk,delr1,delr2); + if (threebody_on) { + jnumm1 = numshort - 1; + + for (jj = 0; jj < jnumm1; jj++) { + j = neighshort[jj]; + jtype = map[type[j]]; + ijparam = elem3param[itype][jtype][jtype]; + delr1[0] = x[j][0] - xtmp; + delr1[1] = x[j][1] - ytmp; + delr1[2] = x[j][2] - ztmp; + rsq1 = delr1[0]*delr1[0] + delr1[1]*delr1[1] + delr1[2]*delr1[2]; + + double fjxtmp,fjytmp,fjztmp; + fjxtmp = fjytmp = fjztmp = 0.0; + + for (kk = jj+1; kk < numshort; kk++) { + k = neighshort[kk]; + ktype = map[type[k]]; + ikparam = elem3param[itype][ktype][ktype]; + ijkparam = elem3param[itype][jtype][ktype]; + + delr2[0] = x[k][0] - xtmp; + delr2[1] = x[k][1] - ytmp; + delr2[2] = x[k][2] - ztmp; + rsq2 = delr2[0]*delr2[0] + delr2[1]*delr2[1] + delr2[2]*delr2[2]; + + threebody(¶ms[ijparam],¶ms[ikparam],¶ms[ijkparam], + rsq1,rsq2,delr1,delr2,fj,fk,eflag,evdwl); + + fxtmp -= fj[0] + fk[0]; + fytmp -= fj[1] + fk[1]; + fztmp -= fj[2] + fk[2]; + fjxtmp += fj[0]; + fjytmp += fj[1]; + fjztmp += fj[2]; + f[k][0] += fk[0]; + f[k][1] += fk[1]; + f[k][2] += fk[2]; + + if (evflag) ev_tally3(i,j,k,evdwl,0.0,fj,fk,delr1,delr2); + } + f[j][0] += fjxtmp; + f[j][1] += fjytmp; + f[j][2] += fjztmp; } - f[j][0] += fjxtmp; - f[j][1] += fjytmp; - f[j][2] += fjztmp; } f[i][0] += fxtmp; f[i][1] += fytmp; @@ -229,9 +230,26 @@ void PairSW::allocate() global settings ------------------------------------------------------------------------- */ -void PairSW::settings(int narg, char **/*arg*/) +void PairSW::settings(int narg, char ** arg) { - if (narg != 0) error->all(FLERR,"Illegal pair_style command"); + // Default + threebody_on = true; + + int iarg = 0; + + while (iarg < narg) { + if (strcmp(arg[iarg],"threebody") == 0) { + if (iarg+2 > narg) error->all(FLERR,"Illegal pair_style command"); + if (strcmp(arg[iarg+1], "on") == 0) { + threebody_on = true; + one_coeff = 1; + } else if (strcmp(arg[iarg+1], "off") == 0) { + threebody_on = false; + one_coeff = 0; // Allow for multiple pair_coeff's + } else error->all(FLERR,"Illegal pair_style command"); + iarg += 2; + } else error->all(FLERR,"Illegal pair_style command"); + } } /* ---------------------------------------------------------------------- diff --git a/src/MANYBODY/pair_sw.h b/src/MANYBODY/pair_sw.h index 8bae7e5282..34fbfa4a4a 100644 --- a/src/MANYBODY/pair_sw.h +++ b/src/MANYBODY/pair_sw.h @@ -52,6 +52,7 @@ class PairSW : public Pair { Param *params; // parameter set for an I-J-K interaction int maxshort; // size of short neighbor list array int *neighshort; // short neighbor list array + bool threebody_on; // whether to run threebody loop void settings(int, char **) override; virtual void allocate(); From b1b580cc041f3092a138e59ca68713268dc41237 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Mon, 27 Jun 2022 17:03:02 -0600 Subject: [PATCH 446/585] Final tidying up --- doc/src/compute_sna_atom.rst | 229 ----------------------- src/{ => ML-SNAP}/compute_grid.cpp | 0 src/{ => ML-SNAP}/compute_grid.h | 0 src/{ => ML-SNAP}/compute_grid_local.cpp | 0 src/{ => ML-SNAP}/compute_grid_local.h | 0 src/ML-SNAP/compute_sna_grid.cpp | 3 +- src/ML-SNAP/compute_sna_grid_local.cpp | 1 + 7 files changed, 3 insertions(+), 230 deletions(-) rename src/{ => ML-SNAP}/compute_grid.cpp (100%) rename src/{ => ML-SNAP}/compute_grid.h (100%) rename src/{ => ML-SNAP}/compute_grid_local.cpp (100%) rename src/{ => ML-SNAP}/compute_grid_local.h (100%) diff --git a/doc/src/compute_sna_atom.rst b/doc/src/compute_sna_atom.rst index 354a9a8fa6..deb717d84d 100644 --- a/doc/src/compute_sna_atom.rst +++ b/doc/src/compute_sna_atom.rst @@ -467,235 +467,6 @@ number of columns in the global array generated by *snap* are 31, and 931, respectively, while the number of rows is 1+3\*\ *N*\ +6, where *N* is the total number of atoms. -If the *quadratic* keyword value is set to 1, then additional columns -are generated, corresponding to the products of all distinct pairs of -bispectrum components. If the number of bispectrum components is *K*, -then the number of distinct pairs is *K*\ (\ *K*\ +1)/2. For compute -*sna/atom* these columns are appended to existing *K* columns. The -ordering of quadratic terms is upper-triangular, (1,1),(1,2)...(1,\ *K*\ -),(2,1)...(\ *K*\ -1,\ *K*\ -1),(\ *K*\ -1,\ *K*\ ),(\ *K*,\ *K*\ ). -For computes *snad/atom* and *snav/atom* each set of *K*\ (\ *K*\ +1)/2 -additional columns is inserted directly after each of sub-block of -linear terms i.e. linear and quadratic terms are contiguous. So the -nesting order from inside to outside is bispectrum component, linear -then quadratic, vector/tensor component, type. - -If the *chem* keyword is used, then the data is arranged into -:math:`N_{elem}^3` sub-blocks, each sub-block corresponding to a -particular chemical labeling :math:`\kappa\lambda\mu` with the last -label changing fastest. Each sub-block contains *K* bispectrum -components. For the purposes of handling contributions to force, virial, -and quadratic combinations, these :math:`N_{elem}^3` sub-blocks are -treated as a single block of :math:`K N_{elem}^3` columns. - -These values can be accessed by any command that uses per-atom values -from a compute as input. See the :doc:`Howto output ` doc -page for an overview of LAMMPS output options. To see how this command -can be used within a Python workflow to train SNAP potentials, see the -examples in `FitSNAP `_. - -The value of all bispectrum components will be zero for atoms not in -the group. Neighbor atoms not in the group do not contribute to the -bispectrum of atoms in the group. - -The neighbor list needed to compute this quantity is constructed each -time the calculation is performed (i.e. each time a snapshot of atoms -is dumped). Thus it can be inefficient to compute/dump this quantity -too frequently. - -The argument *rcutfac* is a scale factor that controls the ratio of -atomic radius to radial cutoff distance. - -The argument *rfac0* and the optional keyword *rmin0* define the -linear mapping from radial distance to polar angle :math:`theta_0` on the -3-sphere, given above. - -The argument *twojmax* defines which -bispectrum components are generated. See section below on output for a -detailed explanation of the number of bispectrum components and the -ordered in which they are listed. - -The keyword *switchflag* can be used to turn off the switching -function :math:`f_c(r)`. - -The keyword *bzeroflag* determines whether or not *B0*, the bispectrum -components of an atom with no neighbors, are subtracted from the -calculated bispectrum components. This optional keyword normally only -affects compute *sna/atom*\ . However, when *quadraticflag* is on, it -also affects *snad/atom* and *snav/atom*\ . - -The keyword *quadraticflag* determines whether or not the quadratic -combinations of bispectrum quantities are generated. These are formed -by taking the outer product of the vector of bispectrum components with -itself. See section below on output for a detailed explanation of the -number of quadratic terms and the ordered in which they are listed. - -The keyword *chem* activates the explicit multi-element variant of the -SNAP bispectrum components. The argument *nelements* specifies the -number of SNAP elements that will be handled. This is followed by -*elementlist*, a list of integers of length *ntypes*, with values in the -range [0, *nelements* ), which maps each LAMMPS type to one of the SNAP -elements. Note that multiple LAMMPS types can be mapped to the same -element, and some elements may be mapped by no LAMMPS type. However, in -typical use cases (training SNAP potentials) the mapping from LAMMPS -types to elements is one-to-one. - -The explicit multi-element variant invoked by the *chem* keyword -partitions the density of neighbors into partial densities for each -chemical element. This is described in detail in the paper by -:ref:`Cusentino et al. ` The bispectrum components are -indexed on ordered triplets of elements: - -.. math:: - - B_{j_1,j_2,j}^{\kappa\lambda\mu} = - \sum_{m_1,m'_1=-j_1}^{j_1}\sum_{m_2,m'_2=-j_2}^{j_2}\sum_{m,m'=-j}^{j} (u^{\mu}_{j,m,m'})^* - H {\scriptscriptstyle \begin{array}{l} {j} {m} {m'} \\ - {j_1} {m_1} {m'_1} \\ - {j_2} {m_2} {m'_2} \end{array}} - u^{\kappa}_{j_1,m_1,m'_1} u^{\lambda}_{j_2,m_2,m'_2} - -where :math:`u^{\mu}_{j,m,m'}` is an expansion coefficient for the partial density of neighbors -of element :math:`\mu` - -.. math:: - - u^{\mu}_{j,m,m'} = w^{self}_{\mu_{i}\mu} U^{j,m,m'}(0,0,0) + \sum_{r_{ii'} < R_{ii'}}{\delta_{\mu\mu_{i'}}f_c(r_{ii'}) w_{\mu_{i'}} U^{j,m,m'}(\theta_0,\theta,\phi)} - -where :math:`w^{self}_{\mu_{i}\mu}` is the self-contribution, which is -either 1 or 0 (see keyword *wselfallflag* below), -:math:`\delta_{\mu\mu_{i'}}` indicates that the sum is only over -neighbor atoms of element :math:`\mu`, and all other quantities are the -same as those appearing in the original equation for :math:`u^j_{m,m'}` -given above. - -The keyword *wselfallflag* defines the rule used for the -self-contribution. If *wselfallflag* is on, then -:math:`w^{self}_{\mu_{i}\mu}` = 1. If it is off then -:math:`w^{self}_{\mu_{i}\mu}` = 0, except in the case of -:math:`{\mu_{i}=\mu}`, when :math:`w^{self}_{\mu_{i}\mu}` = 1. When the -*chem* keyword is not used, this keyword has no effect. - -The keyword *bnormflag* determines whether or not the bispectrum -component :math:`B_{j_1,j_2,j}` is divided by a factor of :math:`2j+1`. -This normalization simplifies force calculations because of the -following symmetry relation - -.. math:: - - \frac{B_{j_1,j_2,j}}{2j+1} = \frac{B_{j,j_2,j_1}}{2j_1+1} = \frac{B_{j_1,j,j_2}}{2j_2+1} - -This option is typically used in conjunction with the *chem* keyword, -and LAMMPS will generate a warning if both *chem* and *bnormflag* -are not both set or not both unset. - -The keyword *bikflag* determines whether or not to expand the bispectrum -rows of the global array returned by compute snap. If *bikflag* is set -to *1* then the bispectrum row, which is typically the per-atom bispectrum -descriptors :math:`B_{i,k}` summed over all atoms *i* to produce -:math:`B_k`, becomes bispectrum rows equal to the number of atoms. Thus, -the resulting bispectrum rows are :math:`B_{i,k}` instead of just -:math:`B_k`. In this case, the entries in the final column for these rows -are set to zero. - -The keyword *switchinnerflag* with value 1 -activates an additional radial switching -function similar to :math:`f_c(r)` above, but acting to switch off -smoothly contributions from neighbor atoms at short separation distances. -This is useful when SNAP is used in combination with a simple -repulsive potential. For a neighbor atom at -distance :math:`r`, its contribution is scaled by a multiplicative -factor :math:`f_{inner}(r)` defined as follows: - -.. math:: - - = & 0, r \leq S_{inner} - D_{inner} \\ - f_{inner}(r) = & \frac{1}{2}(1 - \cos(\frac{\pi}{2} (1 + \frac{r-S_{inner}}{D_{inner}})), S_{inner} - D_{inner} < r \leq S_{inner} + D_{inner} \\ - = & 1, r > S_{inner} + D_{inner} - -where the switching region is centered at :math:`S_{inner}` and it extends a distance :math:`D_{inner}` -to the left and to the right of this. -With this option, additional keywords *sinner* and *dinner* must be used, -each followed by *ntypes* -values for :math:`S_{inner}` and :math:`D_{inner}`, respectively. -When the central atom and the neighbor atom have different types, -the values of :math:`S_{inner}` and :math:`D_{inner}` are -the arithmetic means of the values for both types. - -.. note:: - - If you have a bonded system, then the settings of :doc:`special_bonds - ` command can remove pairwise interactions between - atoms in the same bond, angle, or dihedral. This is the default - setting for the :doc:`special_bonds ` command, and - means those pairwise interactions do not appear in the neighbor list. - Because this fix uses the neighbor list, it also means those pairs - will not be included in the calculation. One way to get around this, - is to write a dump file, and use the :doc:`rerun ` command to - compute the bispectrum components for snapshots in the dump file. - The rerun script can use a :doc:`special_bonds ` - command that includes all pairs in the neighbor list. - ----------- - -Output info -""""""""""" - -Compute *sna/atom* calculates a per-atom array, each column -corresponding to a particular bispectrum component. The total number of -columns and the identity of the bispectrum component contained in each -column depend of the value of *twojmax*, as described by the following -piece of python code: - -.. parsed-literal:: - - for j1 in range(0,twojmax+1): - for j2 in range(0,j1+1): - for j in range(j1-j2,min(twojmax,j1+j2)+1,2): - if (j>=j1): print j1/2.,j2/2.,j/2. - -For even twojmax = 2(*m*\ -1), :math:`K = m(m+1)(2m+1)/6`, the *m*\ -th pyramidal number. For odd twojmax = 2 *m*\ -1, :math:`K = m(m+1)(m+2)/3`, twice the *m*\ -th tetrahedral number. - -.. note:: - - the *diagonal* keyword allowing other possible choices - for the number of bispectrum components was removed in 2019, - since all potentials use the value of 3, corresponding to the - above set of bispectrum components. - -Compute *snad/atom* evaluates a per-atom array. The columns are arranged -into *ntypes* blocks, listed in order of atom type *I*\ . Each block -contains three sub-blocks corresponding to the *x*, *y*, and *z* -components of the atom position. Each of these sub-blocks contains *K* -columns for the *K* bispectrum components, the same as for compute -*sna/atom* - -Compute *snav/atom* evaluates a per-atom array. The columns are arranged -into *ntypes* blocks, listed in order of atom type *I*\ . Each block -contains six sub-blocks corresponding to the *xx*, *yy*, *zz*, -*yz*, *xz*, and *xy* components of the virial tensor in Voigt -notation. Each of these sub-blocks contains *K* columns for the *K* -bispectrum components, the same as for compute *sna/atom* - -Compute *snap* evaluates a global array. The columns are arranged into -*ntypes* blocks, listed in order of atom type *I*\ . Each block contains -one column for each bispectrum component, the same as for compute -*sna/atom*\ . A final column contains the corresponding energy, force -component on an atom, or virial stress component. The rows of the array -appear in the following order: - -* 1 row: *sna/atom* quantities summed for all atoms of type *I* -* 3\*\ *N* rows: *snad/atom* quantities, with derivatives w.r.t. x, y, and z coordinate of atom *i* appearing in consecutive rows. The atoms are sorted based on atom ID. -* 6 rows: *snav/atom* quantities summed for all atoms of type *I* - -For example, if *K* =30 and ntypes=1, the number of columns in the -per-atom arrays generated by *sna/atom*, *snad/atom*, and -*snav/atom* are 30, 90, and 180, respectively. With *quadratic* value=1, -the numbers of columns are 930, 2790, and 5580, respectively. The -number of columns in the global array generated by *snap* are 31, and -931, respectively, while the number of rows is 1+3\*\ *N*\ +6, where *N* -is the total number of atoms. - Compute *sna/grid* evaluates a global array. The array contains one row for each of the :math:`nx \times ny \times nz` grid points, looping over the index for *ix* fastest, diff --git a/src/compute_grid.cpp b/src/ML-SNAP/compute_grid.cpp similarity index 100% rename from src/compute_grid.cpp rename to src/ML-SNAP/compute_grid.cpp diff --git a/src/compute_grid.h b/src/ML-SNAP/compute_grid.h similarity index 100% rename from src/compute_grid.h rename to src/ML-SNAP/compute_grid.h diff --git a/src/compute_grid_local.cpp b/src/ML-SNAP/compute_grid_local.cpp similarity index 100% rename from src/compute_grid_local.cpp rename to src/ML-SNAP/compute_grid_local.cpp diff --git a/src/compute_grid_local.h b/src/ML-SNAP/compute_grid_local.h similarity index 100% rename from src/compute_grid_local.h rename to src/ML-SNAP/compute_grid_local.h diff --git a/src/ML-SNAP/compute_sna_grid.cpp b/src/ML-SNAP/compute_sna_grid.cpp index ac267112b1..771a30eb9f 100644 --- a/src/ML-SNAP/compute_sna_grid.cpp +++ b/src/ML-SNAP/compute_sna_grid.cpp @@ -228,7 +228,8 @@ void ComputeSNAGrid::compute_array() const double ztmp = xgrid[2]; // currently, all grid points are type 1 - + // not clear what a better choice would be + const int itype = 1; int ielem = 0; if (chemflag) ielem = map[itype]; diff --git a/src/ML-SNAP/compute_sna_grid_local.cpp b/src/ML-SNAP/compute_sna_grid_local.cpp index 059f177696..80a1baddab 100644 --- a/src/ML-SNAP/compute_sna_grid_local.cpp +++ b/src/ML-SNAP/compute_sna_grid_local.cpp @@ -227,6 +227,7 @@ void ComputeSNAGridLocal::compute_local() const double ztmp = xgrid[2]; // currently, all grid points are type 1 + // not clear what a better choice would be const int itype = 1; int ielem = 0; From 1d3f865d1b09d8740c0debb7a5142dc84ab1e714 Mon Sep 17 00:00:00 2001 From: jkelowitt <58435724+jkelowitt@users.noreply.github.com> Date: Tue, 28 Jun 2022 00:00:15 -0600 Subject: [PATCH 447/585] Initial changes to the doc --- doc/src/pair_sw.rst | 19 ++++++++++++++++++- 1 file changed, 18 insertions(+), 1 deletion(-) diff --git a/doc/src/pair_sw.rst b/doc/src/pair_sw.rst index 0a6b284b96..a249856371 100644 --- a/doc/src/pair_sw.rst +++ b/doc/src/pair_sw.rst @@ -24,13 +24,17 @@ Syntax pair_style style keyword values * style = *sw* or *sw/mod* -* keyword = *maxdelcs* +* keyword = *maxdelcs* or *threebody* .. parsed-literal:: *maxdelcs* value = delta1 delta2 (optional) delta1 = The minimum thershold for the variation of cosine of three-body angle delta2 = The maximum threshold for the variation of cosine of three-body angle + *threebody* value = *on* or *off* (optional) + on (default) = Compute both the three-body and two-body terms of the potential + off = Compute both only the two-body terms of the potential + Examples """""""" @@ -44,6 +48,10 @@ Examples pair_style sw/mod maxdelcs 0.25 0.35 pair_coeff * * tmd.sw.mod Mo S S + pair_style hybrid sw sw threebody off + pair_coeff * * mW_xL.sw mW NULL + pair_coeff * 2 mW_xL.sw mW xL + Description """"""""""" @@ -111,6 +119,9 @@ This value enables the cut-off function to exclude unnecessary angles in the thr However, the angle variation is much smaller than the given threshold value for actual simulations, so the inconsistency between potential and force can be neglected in actual simulations. +The *threebody* keyword determines whether or not the three-body term of the potential is calculated. Skipping this +significantly increases the speed of the potential, but is only applicable when :math:`\lambda_{ijk} = 0` + Only a single pair_coeff command is used with the *sw* and *sw/mod* styles which specifies a Stillinger-Weber potential file with parameters for all needed elements. These are mapped to LAMMPS atom types by specifying @@ -141,6 +152,12 @@ potential is used as part of the *hybrid* pair style. The NULL values are placeholders for atom types that will be used with other potentials. +.. note:: + + When the *threebody on* keyword is used, multiple pair_coeff commands may + be used to specific the pairs of atoms which don't require three-body term. + In these cases, the first 2 arguments are not required to be \* \*. + Stillinger-Weber files in the *potentials* directory of the LAMMPS distribution have a ".sw" suffix. Lines that are not blank or comments (starting with #) define parameters for a triplet of From 4097d295ce23c30a969be3bddb27aa8acfdbcb9a Mon Sep 17 00:00:00 2001 From: jkelowitt <58435724+jkelowitt@users.noreply.github.com> Date: Tue, 28 Jun 2022 01:37:39 -0600 Subject: [PATCH 448/585] Skip three-body in OpenMP version --- src/OPENMP/pair_sw_omp.cpp | 87 +++++++++++++++++++------------------- 1 file changed, 44 insertions(+), 43 deletions(-) diff --git a/src/OPENMP/pair_sw_omp.cpp b/src/OPENMP/pair_sw_omp.cpp index f6d615b2a1..32df823e31 100644 --- a/src/OPENMP/pair_sw_omp.cpp +++ b/src/OPENMP/pair_sw_omp.cpp @@ -156,50 +156,51 @@ void PairSWOMP::eval(int iifrom, int iito, ThrData * const thr) if (EVFLAG) ev_tally_thr(this,i,j,nlocal,/* newton_pair */ 1, evdwl,0.0,fpair,delx,dely,delz,thr); } - - jnumm1 = numshort - 1; - - for (jj = 0; jj < jnumm1; jj++) { - j = neighshort_thr[jj]; - jtype = map[type[j]]; - ijparam = elem3param[itype][jtype][jtype]; - delr1[0] = x[j].x - xtmp; - delr1[1] = x[j].y - ytmp; - delr1[2] = x[j].z - ztmp; - rsq1 = delr1[0]*delr1[0] + delr1[1]*delr1[1] + delr1[2]*delr1[2]; - - double fjxtmp,fjytmp,fjztmp; - fjxtmp = fjytmp = fjztmp = 0.0; - - for (kk = jj+1; kk < numshort; kk++) { - k = neighshort_thr[kk]; - ktype = map[type[k]]; - ikparam = elem3param[itype][ktype][ktype]; - ijkparam = elem3param[itype][jtype][ktype]; - - delr2[0] = x[k].x - xtmp; - delr2[1] = x[k].y - ytmp; - delr2[2] = x[k].z - ztmp; - rsq2 = delr2[0]*delr2[0] + delr2[1]*delr2[1] + delr2[2]*delr2[2]; - - threebody(¶ms[ijparam],¶ms[ikparam],¶ms[ijkparam], - rsq1,rsq2,delr1,delr2,fj,fk,EFLAG,evdwl); - - fxtmp -= fj[0] + fk[0]; - fytmp -= fj[1] + fk[1]; - fztmp -= fj[2] + fk[2]; - fjxtmp += fj[0]; - fjytmp += fj[1]; - fjztmp += fj[2]; - f[k].x += fk[0]; - f[k].y += fk[1]; - f[k].z += fk[2]; - - if (EVFLAG) ev_tally3_thr(this,i,j,k,evdwl,0.0,fj,fk,delr1,delr2,thr); + if (threebody_on) { + jnumm1 = numshort - 1; + + for (jj = 0; jj < jnumm1; jj++) { + j = neighshort_thr[jj]; + jtype = map[type[j]]; + ijparam = elem3param[itype][jtype][jtype]; + delr1[0] = x[j].x - xtmp; + delr1[1] = x[j].y - ytmp; + delr1[2] = x[j].z - ztmp; + rsq1 = delr1[0]*delr1[0] + delr1[1]*delr1[1] + delr1[2]*delr1[2]; + + double fjxtmp,fjytmp,fjztmp; + fjxtmp = fjytmp = fjztmp = 0.0; + + for (kk = jj+1; kk < numshort; kk++) { + k = neighshort_thr[kk]; + ktype = map[type[k]]; + ikparam = elem3param[itype][ktype][ktype]; + ijkparam = elem3param[itype][jtype][ktype]; + + delr2[0] = x[k].x - xtmp; + delr2[1] = x[k].y - ytmp; + delr2[2] = x[k].z - ztmp; + rsq2 = delr2[0]*delr2[0] + delr2[1]*delr2[1] + delr2[2]*delr2[2]; + + threebody(¶ms[ijparam],¶ms[ikparam],¶ms[ijkparam], + rsq1,rsq2,delr1,delr2,fj,fk,EFLAG,evdwl); + + fxtmp -= fj[0] + fk[0]; + fytmp -= fj[1] + fk[1]; + fztmp -= fj[2] + fk[2]; + fjxtmp += fj[0]; + fjytmp += fj[1]; + fjztmp += fj[2]; + f[k].x += fk[0]; + f[k].y += fk[1]; + f[k].z += fk[2]; + + if (EVFLAG) ev_tally3_thr(this,i,j,k,evdwl,0.0,fj,fk,delr1,delr2,thr); + } + f[j].x += fjxtmp; + f[j].y += fjytmp; + f[j].z += fjztmp; } - f[j].x += fjxtmp; - f[j].y += fjytmp; - f[j].z += fjztmp; } f[i].x += fxtmp; f[i].y += fytmp; From b165c2ca080113877c35c316cbaea7c38d653f36 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 28 Jun 2022 08:39:12 -0400 Subject: [PATCH 449/585] add files to .gitignore after move to package --- src/.gitignore | 4 ++++ 1 file changed, 4 insertions(+) diff --git a/src/.gitignore b/src/.gitignore index 8294a204c7..4c1cf49b3b 100644 --- a/src/.gitignore +++ b/src/.gitignore @@ -173,6 +173,10 @@ /pair_tdpd.cpp /pair_tdpd.h +/compute_grid.cpp +/compute_grid.h +/compute_grid_local.cpp +/compute_grid_local.h /compute_sna_atom.cpp /compute_sna_atom.h /compute_snad_atom.cpp From a9f3108f294586552277b2f21924a31d629f7bfd Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 28 Jun 2022 08:39:20 -0400 Subject: [PATCH 450/585] whitespace --- src/ML-SNAP/compute_sna_grid.cpp | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/src/ML-SNAP/compute_sna_grid.cpp b/src/ML-SNAP/compute_sna_grid.cpp index 771a30eb9f..497390f99a 100644 --- a/src/ML-SNAP/compute_sna_grid.cpp +++ b/src/ML-SNAP/compute_sna_grid.cpp @@ -228,8 +228,8 @@ void ComputeSNAGrid::compute_array() const double ztmp = xgrid[2]; // currently, all grid points are type 1 - // not clear what a better choice would be - + // not clear what a better choice would be + const int itype = 1; int ielem = 0; if (chemflag) ielem = map[itype]; From 9bc1968e366edcb910878badac10dadb6ad5b9f4 Mon Sep 17 00:00:00 2001 From: Stan Gerald Moore Date: Tue, 28 Jun 2022 08:51:07 -0600 Subject: [PATCH 451/585] Add missing grow to Kokkos unpack_exchange --- src/KOKKOS/atom_vec_angle_kokkos.cpp | 3 +++ src/KOKKOS/atom_vec_atomic_kokkos.cpp | 2 ++ src/KOKKOS/atom_vec_bond_kokkos.cpp | 3 +++ src/KOKKOS/atom_vec_charge_kokkos.cpp | 2 ++ src/KOKKOS/atom_vec_dpd_kokkos.cpp | 2 ++ src/KOKKOS/atom_vec_full_kokkos.cpp | 3 +++ src/KOKKOS/atom_vec_molecular_kokkos.cpp | 3 +++ src/KOKKOS/atom_vec_sphere_kokkos.cpp | 2 ++ src/KOKKOS/atom_vec_spin_kokkos.cpp | 2 ++ 9 files changed, 22 insertions(+) diff --git a/src/KOKKOS/atom_vec_angle_kokkos.cpp b/src/KOKKOS/atom_vec_angle_kokkos.cpp index 18de4d46cb..dd37d1a838 100644 --- a/src/KOKKOS/atom_vec_angle_kokkos.cpp +++ b/src/KOKKOS/atom_vec_angle_kokkos.cpp @@ -1391,6 +1391,9 @@ int AtomVecAngleKokkos::unpack_exchange_kokkos(DAT::tdual_xfloat_2d &k_buf,int n int nlocal,int dim,X_FLOAT lo,X_FLOAT hi, ExecutionSpace space) { const size_t elements = 17+atom->maxspecial+2*atom->bond_per_atom+4*atom->angle_per_atom; + + while (nlocal + nrecv/elements >= nmax) grow(0); + if (space == Host) { k_count.h_view(0) = nlocal; AtomVecAngleKokkos_UnpackExchangeFunctor diff --git a/src/KOKKOS/atom_vec_atomic_kokkos.cpp b/src/KOKKOS/atom_vec_atomic_kokkos.cpp index 891ebb51c2..0a78b42227 100644 --- a/src/KOKKOS/atom_vec_atomic_kokkos.cpp +++ b/src/KOKKOS/atom_vec_atomic_kokkos.cpp @@ -649,6 +649,8 @@ struct AtomVecAtomicKokkos_UnpackExchangeFunctor { /* ---------------------------------------------------------------------- */ int AtomVecAtomicKokkos::unpack_exchange_kokkos(DAT::tdual_xfloat_2d &k_buf,int nrecv,int nlocal,int dim,X_FLOAT lo,X_FLOAT hi,ExecutionSpace space) { + while (nlocal + nrecv/11 >= nmax) grow(0); + if (space == Host) { k_count.h_view(0) = nlocal; AtomVecAtomicKokkos_UnpackExchangeFunctor f(atomKK,k_buf,k_count,dim,lo,hi); diff --git a/src/KOKKOS/atom_vec_bond_kokkos.cpp b/src/KOKKOS/atom_vec_bond_kokkos.cpp index 3655d894c9..ea70f15dcb 100644 --- a/src/KOKKOS/atom_vec_bond_kokkos.cpp +++ b/src/KOKKOS/atom_vec_bond_kokkos.cpp @@ -845,6 +845,9 @@ int AtomVecBondKokkos::unpack_exchange_kokkos(DAT::tdual_xfloat_2d &k_buf,int nr int nlocal,int dim,X_FLOAT lo,X_FLOAT hi, ExecutionSpace space) { const size_t elements = 16+atomKK->maxspecial+atomKK->bond_per_atom+atomKK->bond_per_atom; + + while (nlocal + nrecv/elements >= nmax) grow(0); + if (space == Host) { k_count.h_view(0) = nlocal; AtomVecBondKokkos_UnpackExchangeFunctor diff --git a/src/KOKKOS/atom_vec_charge_kokkos.cpp b/src/KOKKOS/atom_vec_charge_kokkos.cpp index 7de36ffd5d..3c0e1d46bb 100644 --- a/src/KOKKOS/atom_vec_charge_kokkos.cpp +++ b/src/KOKKOS/atom_vec_charge_kokkos.cpp @@ -774,6 +774,8 @@ struct AtomVecChargeKokkos_UnpackExchangeFunctor { int AtomVecChargeKokkos::unpack_exchange_kokkos(DAT::tdual_xfloat_2d &k_buf,int nrecv, int nlocal,int dim,X_FLOAT lo,X_FLOAT hi, ExecutionSpace space) { + while (nlocal + nrecv/12 >= nmax) grow(0); + if (space == Host) { k_count.h_view(0) = nlocal; AtomVecChargeKokkos_UnpackExchangeFunctor f(atomKK,k_buf,k_count,dim,lo,hi); diff --git a/src/KOKKOS/atom_vec_dpd_kokkos.cpp b/src/KOKKOS/atom_vec_dpd_kokkos.cpp index cf7ad9d533..1b7ccd97d0 100644 --- a/src/KOKKOS/atom_vec_dpd_kokkos.cpp +++ b/src/KOKKOS/atom_vec_dpd_kokkos.cpp @@ -1505,6 +1505,8 @@ struct AtomVecDPDKokkos_UnpackExchangeFunctor { /* ---------------------------------------------------------------------- */ int AtomVecDPDKokkos::unpack_exchange_kokkos(DAT::tdual_xfloat_2d &k_buf,int nrecv,int nlocal,int dim,X_FLOAT lo,X_FLOAT hi,ExecutionSpace space) { + while (nlocal + nrecv/17 >= nmax) grow(0); + if (space == Host) { k_count.h_view(0) = nlocal; AtomVecDPDKokkos_UnpackExchangeFunctor f(atomKK,k_buf,k_count,dim,lo,hi); diff --git a/src/KOKKOS/atom_vec_full_kokkos.cpp b/src/KOKKOS/atom_vec_full_kokkos.cpp index b75c33e046..7322a75b11 100644 --- a/src/KOKKOS/atom_vec_full_kokkos.cpp +++ b/src/KOKKOS/atom_vec_full_kokkos.cpp @@ -1186,6 +1186,9 @@ int AtomVecFullKokkos::unpack_exchange_kokkos(DAT::tdual_xfloat_2d &k_buf,int nr ExecutionSpace space) { const size_t elements = 20+atom->maxspecial+2*atom->bond_per_atom+4*atom->angle_per_atom+ 5*atom->dihedral_per_atom + 5*atom->improper_per_atom; + + while (nlocal + nrecv/elements >= nmax) grow(0); + if (space == Host) { k_count.h_view(0) = nlocal; AtomVecFullKokkos_UnpackExchangeFunctor diff --git a/src/KOKKOS/atom_vec_molecular_kokkos.cpp b/src/KOKKOS/atom_vec_molecular_kokkos.cpp index c4e75c1da7..123adedbdf 100644 --- a/src/KOKKOS/atom_vec_molecular_kokkos.cpp +++ b/src/KOKKOS/atom_vec_molecular_kokkos.cpp @@ -1594,6 +1594,9 @@ int AtomVecMolecularKokkos::unpack_exchange_kokkos(DAT::tdual_xfloat_2d &k_buf,i ExecutionSpace space) { const size_t elements = 19+atom->maxspecial+2*atom->bond_per_atom+4*atom->angle_per_atom+ 5*atom->dihedral_per_atom + 5*atom->improper_per_atom; + + while (nlocal + nrecv/elements >= nmax) grow(0); + if (space == Host) { k_count.h_view(0) = nlocal; AtomVecMolecularKokkos_UnpackExchangeFunctor diff --git a/src/KOKKOS/atom_vec_sphere_kokkos.cpp b/src/KOKKOS/atom_vec_sphere_kokkos.cpp index 0b722e8563..206d6c832c 100644 --- a/src/KOKKOS/atom_vec_sphere_kokkos.cpp +++ b/src/KOKKOS/atom_vec_sphere_kokkos.cpp @@ -2341,6 +2341,8 @@ struct AtomVecSphereKokkos_UnpackExchangeFunctor { /* ---------------------------------------------------------------------- */ int AtomVecSphereKokkos::unpack_exchange_kokkos(DAT::tdual_xfloat_2d &k_buf,int nrecv,int nlocal,int dim,X_FLOAT lo,X_FLOAT hi,ExecutionSpace space) { + while (nlocal + nrecv/16 >= nmax) grow(0); + if (space == Host) { k_count.h_view(0) = nlocal; AtomVecSphereKokkos_UnpackExchangeFunctor f(atomKK,k_buf,k_count,dim,lo,hi); diff --git a/src/KOKKOS/atom_vec_spin_kokkos.cpp b/src/KOKKOS/atom_vec_spin_kokkos.cpp index 039c08f31c..7722241756 100644 --- a/src/KOKKOS/atom_vec_spin_kokkos.cpp +++ b/src/KOKKOS/atom_vec_spin_kokkos.cpp @@ -863,6 +863,8 @@ struct AtomVecSpinKokkos_UnpackExchangeFunctor { int AtomVecSpinKokkos::unpack_exchange_kokkos(DAT::tdual_xfloat_2d &k_buf,int nrecv, int nlocal,int dim,X_FLOAT lo,X_FLOAT hi, ExecutionSpace space) { + while (nlocal + nrecv/15 >= nmax) grow(0); + if(space == Host) { k_count.h_view(0) = nlocal; AtomVecSpinKokkos_UnpackExchangeFunctor f(atomKK,k_buf,k_count,dim,lo,hi); From 192c80826b0597a6021a0dbcb6998a285964456d Mon Sep 17 00:00:00 2001 From: Stan Gerald Moore Date: Tue, 28 Jun 2022 08:51:23 -0600 Subject: [PATCH 452/585] Fix small memory leak in SNAP --- src/ML-SNAP/pair_snap.cpp | 7 ++----- 1 file changed, 2 insertions(+), 5 deletions(-) diff --git a/src/ML-SNAP/pair_snap.cpp b/src/ML-SNAP/pair_snap.cpp index 07a8237ab5..7c6e0a8b5d 100644 --- a/src/ML-SNAP/pair_snap.cpp +++ b/src/ML-SNAP/pair_snap.cpp @@ -63,11 +63,8 @@ PairSNAP::~PairSNAP() memory->destroy(radelem); memory->destroy(wjelem); memory->destroy(coeffelem); - - if (switchinnerflag) { - memory->destroy(sinnerelem); - memory->destroy(dinnerelem); - } + memory->destroy(sinnerelem); + memory->destroy(dinnerelem); memory->destroy(beta); memory->destroy(bispectrum); From f497afa7638f4af4f33086bf9b01a2f295284f6a Mon Sep 17 00:00:00 2001 From: Stan Gerald Moore Date: Tue, 28 Jun 2022 08:51:42 -0600 Subject: [PATCH 453/585] Small tweaks --- src/KOKKOS/min_kokkos.cpp | 8 ++++++-- src/KOKKOS/verlet_kokkos.cpp | 5 ----- 2 files changed, 6 insertions(+), 7 deletions(-) diff --git a/src/KOKKOS/min_kokkos.cpp b/src/KOKKOS/min_kokkos.cpp index 8dc7b68287..7fe690c823 100644 --- a/src/KOKKOS/min_kokkos.cpp +++ b/src/KOKKOS/min_kokkos.cpp @@ -79,6 +79,8 @@ void MinKokkos::setup(int flag) } update->setupflag = 1; + lmp->kokkos->auto_sync = 1; + // setup extra global dof due to fixes // cannot be done in init() b/c update init() is before modify init() @@ -170,7 +172,7 @@ void MinKokkos::setup(int flag) } else if (force->pair) force->pair->compute_dummy(eflag,vflag); - if (atomKK->molecular) { + if (atom->molecular != Atom::ATOMIC) { if (force->bond) { atomKK->sync(force->bond->execution_space,force->bond->datamask_read); force->bond->compute(eflag,vflag); @@ -242,6 +244,8 @@ void MinKokkos::setup_minimal(int flag) // acquire ghosts // build neighbor lists + lmp->kokkos->auto_sync = 1; + if (flag) { modify->setup_pre_exchange(); if (triclinic) domain->x2lamda(atom->nlocal); @@ -277,7 +281,7 @@ void MinKokkos::setup_minimal(int flag) } else if (force->pair) force->pair->compute_dummy(eflag,vflag); - if (atomKK->molecular) { + if (atom->molecular != Atom::ATOMIC) { if (force->bond) { atomKK->sync(force->bond->execution_space,force->bond->datamask_read); force->bond->compute(eflag,vflag); diff --git a/src/KOKKOS/verlet_kokkos.cpp b/src/KOKKOS/verlet_kokkos.cpp index 1816415b47..573a6118b9 100644 --- a/src/KOKKOS/verlet_kokkos.cpp +++ b/src/KOKKOS/verlet_kokkos.cpp @@ -282,8 +282,6 @@ void VerletKokkos::run(int n) f_merge_copy = DAT::t_f_array("VerletKokkos::f_merge_copy",atomKK->k_f.extent(0)); atomKK->sync(Device,ALL_MASK); - //static double time = 0.0; - //Kokkos::Timer ktimer; timer->init_timeout(); for (int i = 0; i < n; i++) { @@ -297,10 +295,8 @@ void VerletKokkos::run(int n) // initial time integration - //ktimer.reset(); timer->stamp(); modify->initial_integrate(vflag); - //time += ktimer.seconds(); if (n_post_integrate) modify->post_integrate(); timer->stamp(Timer::MODIFY); @@ -445,7 +441,6 @@ void VerletKokkos::run(int n) if (pair_compute_flag) { atomKK->sync(force->pair->execution_space,force->pair->datamask_read); atomKK->sync(force->pair->execution_space,~(~force->pair->datamask_read|(F_MASK | ENERGY_MASK | VIRIAL_MASK))); - Kokkos::Timer ktimer; force->pair->compute(eflag,vflag); atomKK->modified(force->pair->execution_space,force->pair->datamask_modify); atomKK->modified(force->pair->execution_space,~(~force->pair->datamask_modify|(F_MASK | ENERGY_MASK | VIRIAL_MASK))); From a279ab38603e5c12e5c5cceb64ee856515f66491 Mon Sep 17 00:00:00 2001 From: Stan Moore Date: Tue, 28 Jun 2022 11:32:48 -0600 Subject: [PATCH 454/585] Prevent view bounds error when a proc has no atoms --- src/KOKKOS/npair_kokkos.cpp | 3 +++ 1 file changed, 3 insertions(+) diff --git a/src/KOKKOS/npair_kokkos.cpp b/src/KOKKOS/npair_kokkos.cpp index 5be91fed4a..a1f8fcbf48 100644 --- a/src/KOKKOS/npair_kokkos.cpp +++ b/src/KOKKOS/npair_kokkos.cpp @@ -153,6 +153,9 @@ void NPairKokkos::build(NeighList *list_) int nall = nlocal; if (GHOST) nall += atom->nghost; + + if (nall == 0) return; + list->grow(nall); NeighborKokkosExecute From ae1a33aa5afd455b798179e5ab3c3044518acc36 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 28 Jun 2022 13:36:49 -0400 Subject: [PATCH 455/585] update unit test --- unittest/cplusplus/test_lammps_class.cpp | 6 +++--- 1 file changed, 3 insertions(+), 3 deletions(-) diff --git a/unittest/cplusplus/test_lammps_class.cpp b/unittest/cplusplus/test_lammps_class.cpp index d25bf43656..64ce1eefb1 100644 --- a/unittest/cplusplus/test_lammps_class.cpp +++ b/unittest/cplusplus/test_lammps_class.cpp @@ -83,8 +83,8 @@ TEST_F(LAMMPS_plain, InitMembers) EXPECT_STREQ(lmp->exename, "LAMMPS_test"); EXPECT_EQ(lmp->num_package, 0); - EXPECT_EQ(lmp->clientserver, 0); + EXPECT_EQ(lmp->mdicomm, nullptr); EXPECT_EQ(lmp->kokkos, nullptr); EXPECT_EQ(lmp->atomKK, nullptr); EXPECT_EQ(lmp->memoryKK, nullptr); @@ -218,8 +218,8 @@ TEST_F(LAMMPS_omp, InitMembers) EXPECT_STREQ(lmp->exename, "LAMMPS_test"); EXPECT_EQ(lmp->num_package, 1); - EXPECT_EQ(lmp->clientserver, 0); + EXPECT_EQ(lmp->mdicomm, nullptr); EXPECT_EQ(lmp->kokkos, nullptr); EXPECT_EQ(lmp->atomKK, nullptr); EXPECT_EQ(lmp->memoryKK, nullptr); @@ -302,12 +302,12 @@ TEST_F(LAMMPS_kokkos, InitMembers) EXPECT_STREQ(lmp->exename, "LAMMPS_test"); EXPECT_EQ(lmp->num_package, 0); - EXPECT_EQ(lmp->clientserver, 0); if (Info::has_accelerator_feature("KOKKOS", "api", "openmp")) EXPECT_EQ(lmp->comm->nthreads, 2); else EXPECT_EQ(lmp->comm->nthreads, 1); + EXPECT_EQ(lmp->mdicomm, nullptr); EXPECT_NE(lmp->kokkos, nullptr); EXPECT_NE(lmp->atomKK, nullptr); EXPECT_NE(lmp->memoryKK, nullptr); From 7aabbba7fffaa7215ca621b3098725c34dfc770e Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 28 Jun 2022 13:37:33 -0400 Subject: [PATCH 456/585] whitespace --- doc/src/fix_mdi_qm.rst | 2 +- src/MDI/fix_mdi_qm.cpp | 22 +++++++++++----------- src/MDI/mdi_command.cpp | 4 ++-- src/MDI/mdi_engine.cpp | 4 ++-- 4 files changed, 16 insertions(+), 16 deletions(-) diff --git a/doc/src/fix_mdi_qm.rst b/doc/src/fix_mdi_qm.rst index a00f6e2edc..a6c2b6c744 100644 --- a/doc/src/fix_mdi_qm.rst +++ b/doc/src/fix_mdi_qm.rst @@ -141,7 +141,7 @@ directory. See its README file for more details. (1) To run an ab initio MD (AIMD) dynamics simulation, or an energy minimization with QM forces, or a multi-replica NEB calculation, use *add yes* and *every 1* (the defaults). This is so that every time -LAMMPS needs energy and forces, the QM code will be invoked. +LAMMPS needs energy and forces, the QM code will be invoked. Both LAMMPS and the QM code should define the same system (simulation box, atoms and their types) in their respective input scripts. Note diff --git a/src/MDI/fix_mdi_qm.cpp b/src/MDI/fix_mdi_qm.cpp index 1c725a0871..db1c59ada9 100644 --- a/src/MDI/fix_mdi_qm.cpp +++ b/src/MDI/fix_mdi_qm.cpp @@ -33,7 +33,7 @@ FixMDIQM::FixMDIQM(LAMMPS *lmp, int narg, char **arg) : Fix(lmp, narg, arg) { // check requirements for LAMMPS to work with MDI as an engine - if (atom->tag_enable == 0) + if (atom->tag_enable == 0) error->all(FLERR, "Cannot use MDI engine without atom IDs"); if (atom->natoms && atom->tag_consecutive() == 0) error->all(FLERR, "MDI engine requires consecutive atom IDs"); @@ -201,7 +201,7 @@ void FixMDIQM::init() // this fix makes one-time connection to engine if (connectflag) { - + // if MDI's mdicomm not set, need to Accept_comm() with stand-alone engine // othewise are already connected to plugin engine @@ -210,24 +210,24 @@ void FixMDIQM::init() if (mdicomm == MDI_COMM_NULL) { plugin = 0; MDI_Accept_communicator(&mdicomm); - if (mdicomm == MDI_COMM_NULL) + if (mdicomm == MDI_COMM_NULL) error->all(FLERR, "MDI unable to connect to stand-alone engine"); } else { plugin = 1; int method; MDI_Get_method(&method, mdicomm); - if (method != MDI_PLUGIN) + if (method != MDI_PLUGIN) error->all(FLERR, "MDI internal error for plugin engine"); } - + // connection should have been already made by "mdi connect" command // only works for stand-alone engines } else { plugin = 0; - if (lmp->mdicomm == nullptr) + if (lmp->mdicomm == nullptr) error->all(FLERR,"Fix mdi/qm is not connected to engine via mdi connect"); int nbytes = sizeof(MDI_Comm); @@ -424,7 +424,7 @@ void FixMDIQM::reallocate() bigint nsize = atom->natoms * 3; if (nsize > MAXSMALLINT) error->all(FLERR, "Natoms too large to use with fix mdi/qm"); - + maxbuf = static_cast (atom->natoms); memory->destroy(ibuf1); memory->destroy(buf3); @@ -447,10 +447,10 @@ void FixMDIQM::send_types() // use local atomID to index into ordered ibuf1 - tagint *tag = atom->tag; + tagint *tag = atom->tag; int *type = atom->type; int nlocal = atom->nlocal; - + int index; for (int i = 0; i < nlocal; i++) { index = static_cast(tag[i]) - 1; @@ -476,10 +476,10 @@ void FixMDIQM::send_elements() // use local atomID to index into ordered ibuf1 - tagint *tag = atom->tag; + tagint *tag = atom->tag; int *type = atom->type; int nlocal = atom->nlocal; - + int index; for (int i = 0; i < nlocal; i++) { index = static_cast(tag[i]) - 1; diff --git a/src/MDI/mdi_command.cpp b/src/MDI/mdi_command.cpp index 96ba839dfc..42d8b2691a 100644 --- a/src/MDI/mdi_command.cpp +++ b/src/MDI/mdi_command.cpp @@ -26,7 +26,7 @@ using namespace LAMMPS_NS; mdi command: engine or plugin or connect or exit engine is used when LAMMPS is an MDI engine, to start listening for requests plugin is used when LAMMPS is an MDI driver to load a plugin library - connect and exit are used when LAMMPS is an MDI driver to + connect and exit are used when LAMMPS is an MDI driver to (a) connect = setup comm with a stand-alone MDI engine (b) exit = terminate comm with a stand-alone MDI engine ---------------------------------------------------------------------- */ @@ -51,7 +51,7 @@ void MDICommand::command(int narg, char **arg) if (mdicomm == MDI_COMM_NULL) { MDI_Accept_communicator(&mdicomm); - if (mdicomm == MDI_COMM_NULL) + if (mdicomm == MDI_COMM_NULL) error->all(FLERR, "MDI unable to connect to stand-alone engine"); } else error->all(FLERR, "Cannot use mdi connect with plugin engine"); diff --git a/src/MDI/mdi_engine.cpp b/src/MDI/mdi_engine.cpp index 79bfbe097e..91774659ff 100644 --- a/src/MDI/mdi_engine.cpp +++ b/src/MDI/mdi_engine.cpp @@ -101,7 +101,7 @@ MDIEngine::MDIEngine(LAMMPS *_lmp, int narg, char ** arg) : Pointers(_lmp) for (int i = 1; i < ntypes; i++) for (int j = i+1; j <= ntypes; j++) { if (elements[i] == 0 || elements[j] == 0) continue; - if (elements[i] == elements[j]) + if (elements[i] == elements[j]) error->all(FLERR,"MDI engine element cannot map to multiple types"); } } @@ -1227,7 +1227,7 @@ void MDIEngine::receive_elements() break; } } - if (itype > ntypes) + if (itype > ntypes) error->all(FLERR,"MDI element not found in element list"); } } From 56cb2f3077a814a4035cdc7cf05175408e89e558 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 28 Jun 2022 13:44:41 -0400 Subject: [PATCH 457/585] update external library version and md5sum --- cmake/Modules/Packages/MDI.cmake | 4 ++-- lib/mdi/Install.py | 2 +- 2 files changed, 3 insertions(+), 3 deletions(-) diff --git a/cmake/Modules/Packages/MDI.cmake b/cmake/Modules/Packages/MDI.cmake index 88859f0285..90188f91a8 100644 --- a/cmake/Modules/Packages/MDI.cmake +++ b/cmake/Modules/Packages/MDI.cmake @@ -8,8 +8,8 @@ option(DOWNLOAD_MDI "Download and compile the MDI library instead of using an al if(DOWNLOAD_MDI) message(STATUS "MDI download requested - we will build our own") - set(MDI_URL "https://github.com/MolSSI-MDI/MDI_Library/archive/v1.3.2.tar.gz" CACHE STRING "URL for MDI tarball") - set(MDI_MD5 "836f5da400d8cff0f0e4435640f9454f" CACHE STRING "MD5 checksum for MDI tarball") + set(MDI_URL "https://github.com/MolSSI-MDI/MDI_Library/archive/v1.4.1.tar.gz" CACHE STRING "URL for MDI tarball") + set(MDI_MD5 "f9505fccd4c79301a619f6452dad4ad9" CACHE STRING "MD5 checksum for MDI tarball") mark_as_advanced(MDI_URL) mark_as_advanced(MDI_MD5) enable_language(C) diff --git a/lib/mdi/Install.py b/lib/mdi/Install.py index 48d4952f9b..940a49555c 100644 --- a/lib/mdi/Install.py +++ b/lib/mdi/Install.py @@ -39,7 +39,7 @@ url = "https://github.com/MolSSI-MDI/MDI_Library/archive/v%s.tar.gz" % version # known checksums for different MDI versions. used to validate the download. checksums = { \ - '1.3.2' : '836f5da400d8cff0f0e4435640f9454f', \ + '1.4.1' : 'f9505fccd4c79301a619f6452dad4ad9', \ } # print error message or help From 03962ba0f4c73f88bbbb05279eeab7940c162be9 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 28 Jun 2022 13:55:48 -0400 Subject: [PATCH 458/585] fix spelling in MDI docs --- doc/src/Howto_mdi.rst | 2 +- doc/src/Packages_details.rst | 2 +- doc/src/fix_mdi_qm.rst | 14 +++++++------- doc/src/mdi.rst | 8 ++++---- doc/utils/sphinx-config/false_positives.txt | 6 ++++++ 5 files changed, 19 insertions(+), 13 deletions(-) diff --git a/doc/src/Howto_mdi.rst b/doc/src/Howto_mdi.rst index 578f98e61e..14bef1a546 100644 --- a/doc/src/Howto_mdi.rst +++ b/doc/src/Howto_mdi.rst @@ -72,7 +72,7 @@ either a stand-alone code or a plugin library. As explained on the `fix mdi/qm ` command doc page, it can be used to perform *ab initio* MD simulations or energy minimizations, -or to evalute the quantum energy and forces for a series of +or to evaluate the quantum energy and forces for a series of independent systems. The examples/mdi directory has example input scripts for all of these use cases. diff --git a/doc/src/Packages_details.rst b/doc/src/Packages_details.rst index 65bab0e5a2..59922bd939 100644 --- a/doc/src/Packages_details.rst +++ b/doc/src/Packages_details.rst @@ -1479,7 +1479,7 @@ the :doc:`Build extras ` page. * lib/mdi/README * :doc:`Howto MDI ` * :doc:`mdi ` -* :doc:`fix mdi/aimd ` +* :doc:`fix mdi/qm ` * examples/PACKAGES/mdi ---------- diff --git a/doc/src/fix_mdi_qm.rst b/doc/src/fix_mdi_qm.rst index a6c2b6c744..ca47db5e7a 100644 --- a/doc/src/fix_mdi_qm.rst +++ b/doc/src/fix_mdi_qm.rst @@ -57,9 +57,9 @@ explained below. These are example use cases for this fix, discussed further below: -* perform an ab intitio MD (AIMD) simulation with quantum forces -* perform an energy minimziation with quantum forces -* perform a nudged elatic band (NEB) calculation with quantum forces +* perform an ab initio MD (AIMD) simulation with quantum forces +* perform an energy minimization with quantum forces +* perform a nudged elastic band (NEB) calculation with quantum forces * perform a QM calculation for a series of independent systems which LAMMPS reads or generates The code coupling performed by this command is done via the `MDI @@ -71,7 +71,7 @@ information about how LAMMPS can operate as either an MDI driver or engine. The examples/mdi directory contains input scripts using this fix in -the various use cases dicussed below. In each case, two instances of +the various use cases discussed below. In each case, two instances of LAMMPS are used, once as an MDI driver, once as an MDI engine (surrogate for a QM code). The examples/mdi/README file explains how to launch two codes so that they communicate via the MDI library using @@ -157,7 +157,7 @@ atom coordinates. The engine code computes quantum forces on each atom and the total energy of the system and returns them to LAMMPS. Note that if the AIMD simulation is an NPT or NPH model, or the energy -minimization includesf :doc:`fix box relax ` to +minimization includes :doc:`fix box relax ` to equilibrate the box size/shape, then LAMMPS computes a pressure. This means the *virial* keyword should be set to *yes* so that the QM contribution to the pressure can be included. @@ -172,7 +172,7 @@ atom coordinates and QM forces to a file. Likewise the QM energy and virial could be output with the :doc:`thermo_style custom ` command. -(3) To do a QM evaulation of energy and forces for a series of *N* +(3) To do a QM evaluation of energy and forces for a series of *N* independent systems (simulation box and atoms), use *add no* and *every 1*. Write a LAMMPS input script which loops over the *N* systems. See the :doc:`Howto multiple ` doc page for @@ -180,7 +180,7 @@ details on looping and removing old systems. The series of systems could be initialized by reading them from data files with :doc:`read_data ` commands. Or, for example, by using the :doc:`lattice ` , :doc:`create_atoms `, -:doc:`delete_atoms `, and/or :doc:`displace_atoms +:doc:`delete_atoms `, and/or :doc:`displace_atoms random ` commands to generate a series of different systems. At the end of the loop perform :doc:`run 0 ` and :doc:`write_dump ` commands to invoke the QM code and diff --git a/doc/src/mdi.rst b/doc/src/mdi.rst index 2591b3ea16..b5ee0098bd 100644 --- a/doc/src/mdi.rst +++ b/doc/src/mdi.rst @@ -326,15 +326,15 @@ able to initiate and terminate the connection to the engine code. The only current MDI driver command in LAMMPS is the :doc:`fix mdi/qm ` command. If it is only used once in an input script then it can initiate and terminate the connection. But if it is being -issuedd multiple times, e.g. in a loop that issues a :doc:`clear -` command, then it cannot initiate/terminate the connection +issued multiple times, e.g. in a loop that issues a :doc:`clear +` command, then it cannot initiate or terminate the connection multiple times. Instead, the *mdi connect* and *mdi exit* commands -should be used outside the loop to intiate/terminate the connection. +should be used outside the loop to initiate or terminate the connection. See the examples/mdi/in.series.driver script for an example of how this is done. The LOOP in that script is reading a series of data file configurations and passing them to an MDI engine (e.g. quantum -code) for enery and force evaluation. A *clear* command inside the +code) for energy and force evaluation. A *clear* command inside the loop wipes out the current system so a new one can be defined. This operation also destroys all fixes. So the :doc:`fix mdi/qm ` command is issued once per loop iteration. Note that it diff --git a/doc/utils/sphinx-config/false_positives.txt b/doc/utils/sphinx-config/false_positives.txt index abc6b47ccd..77a1da6643 100644 --- a/doc/utils/sphinx-config/false_positives.txt +++ b/doc/utils/sphinx-config/false_positives.txt @@ -3679,13 +3679,19 @@ vx Vx vxcm vxmu +vxx +vxy +vxz vy Vy vycm +vyy +vyz vz Vz vzcm vzi +vzz Waals Wadley wallstyle From 56e120702403425e6fcfc93714e426725ef24d5a Mon Sep 17 00:00:00 2001 From: Stan Moore Date: Tue, 28 Jun 2022 12:03:34 -0600 Subject: [PATCH 459/585] Add missing GPU <--> CPU data transfer in minimize Kokkos --- src/KOKKOS/min_cg_kokkos.cpp | 2 ++ src/KOKKOS/min_kokkos.cpp | 3 +++ src/KOKKOS/min_linesearch_kokkos.cpp | 11 ++++++----- src/KOKKOS/pair_snap_kokkos_impl.h | 2 +- src/KOKKOS/pair_zbl_kokkos.cpp | 5 +++-- 5 files changed, 15 insertions(+), 8 deletions(-) diff --git a/src/KOKKOS/min_cg_kokkos.cpp b/src/KOKKOS/min_cg_kokkos.cpp index 32f97437c7..53c4031f9b 100644 --- a/src/KOKKOS/min_cg_kokkos.cpp +++ b/src/KOKKOS/min_cg_kokkos.cpp @@ -49,6 +49,8 @@ int MinCGKokkos::iterate(int maxiter) fix_minimize_kk->k_vectors.sync(); fix_minimize_kk->k_vectors.modify(); + atomKK->sync(Device,F_MASK); + // nlimit = max # of CG iterations before restarting // set to ndoftotal unless too big diff --git a/src/KOKKOS/min_kokkos.cpp b/src/KOKKOS/min_kokkos.cpp index 7fe690c823..9aebd80d2e 100644 --- a/src/KOKKOS/min_kokkos.cpp +++ b/src/KOKKOS/min_kokkos.cpp @@ -580,6 +580,7 @@ void MinKokkos::force_clear() double MinKokkos::fnorm_sqr() { + atomKK->sync(Device,F_MASK); double local_norm2_sqr = 0.0; { @@ -608,6 +609,7 @@ double MinKokkos::fnorm_sqr() double MinKokkos::fnorm_inf() { + atomKK->sync(Device,F_MASK); double local_norm_inf = 0.0; { @@ -636,6 +638,7 @@ double MinKokkos::fnorm_inf() double MinKokkos::fnorm_max() { + atomKK->sync(Device,F_MASK); double local_norm_max = 0.0; { diff --git a/src/KOKKOS/min_linesearch_kokkos.cpp b/src/KOKKOS/min_linesearch_kokkos.cpp index 2fad14f3b4..cb97a34e50 100644 --- a/src/KOKKOS/min_linesearch_kokkos.cpp +++ b/src/KOKKOS/min_linesearch_kokkos.cpp @@ -111,9 +111,6 @@ void MinLineSearchKokkos::reset_vectors() x0 = fix_minimize_kk->request_vector_kokkos(0); g = fix_minimize_kk->request_vector_kokkos(1); h = fix_minimize_kk->request_vector_kokkos(2); - - auto h_fvec = Kokkos::create_mirror_view(fvec); - Kokkos::deep_copy(h_fvec,fvec); } /* ---------------------------------------------------------------------- @@ -181,6 +178,8 @@ int MinLineSearchKokkos::linemin_quadratic(double eoriginal, double &alpha) fix_minimize_kk->k_vectors.sync(); fix_minimize_kk->k_vectors.modify(); + atomKK->sync(Device,X_MASK|F_MASK); + // fdothall = projection of search dir along downhill gradient // if search direction is not downhill, exit with error @@ -364,8 +363,8 @@ double MinLineSearchKokkos::alpha_step(double alpha, int resetflag) // reset to starting point if (nextra_global) modify->min_step(0.0,hextra); - atomKK->k_x.clear_sync_state(); // ignore if host positions since device - // positions will be reset below + atomKK->k_x.clear_sync_state(); // ignore if host positions modified since + // device positions will be reset below { // local variables for lambda capture @@ -409,6 +408,8 @@ double MinLineSearchKokkos::compute_dir_deriv(double &ff) double dot[2],dotall[2]; double fh; + atomKK->sync(Device,F_MASK); + // compute new fh, alpha, delfh s_double2 sdot; diff --git a/src/KOKKOS/pair_snap_kokkos_impl.h b/src/KOKKOS/pair_snap_kokkos_impl.h index 0656a1f9ee..d36497964e 100644 --- a/src/KOKKOS/pair_snap_kokkos_impl.h +++ b/src/KOKKOS/pair_snap_kokkos_impl.h @@ -139,7 +139,7 @@ template void PairSNAPKokkos::compute(int eflag_in, int vflag_in) { if (host_flag) { - atomKK->sync(Host,X_MASK|TYPE_MASK); + atomKK->sync(Host,X_MASK|F_MASK|TYPE_MASK); PairSNAP::compute(eflag_in,vflag_in); atomKK->modified(Host,F_MASK); return; diff --git a/src/KOKKOS/pair_zbl_kokkos.cpp b/src/KOKKOS/pair_zbl_kokkos.cpp index 316c583717..e881196e5e 100644 --- a/src/KOKKOS/pair_zbl_kokkos.cpp +++ b/src/KOKKOS/pair_zbl_kokkos.cpp @@ -126,8 +126,6 @@ void PairZBLKokkos::compute(int eflag_in, int vflag_in) } atomKK->sync(execution_space,datamask_read); - if (eflag || vflag) atomKK->modified(execution_space,datamask_modify); - else atomKK->modified(execution_space,F_MASK); x = atomKK->k_x.view(); f = atomKK->k_f.view(); @@ -177,6 +175,9 @@ void PairZBLKokkos::compute(int eflag_in, int vflag_in) } if (vflag_fdotr) pair_virial_fdotr_compute(this); + + if (eflag || vflag) atomKK->modified(execution_space,datamask_modify); + else atomKK->modified(execution_space,F_MASK); } template From 373c719f4f7821d5a7a5da3fb092a97794dbd9f8 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 28 Jun 2022 15:22:54 -0400 Subject: [PATCH 460/585] make compilation settings consistent with CMake --- lib/mdi/Install.py | 6 +++--- lib/mdi/Makefile.g++ | 2 +- lib/mdi/Makefile.gcc | 2 +- lib/mdi/Makefile.icc | 2 +- lib/mdi/Makefile.mpi | 2 +- 5 files changed, 7 insertions(+), 7 deletions(-) diff --git a/lib/mdi/Install.py b/lib/mdi/Install.py index 940a49555c..5452853b82 100644 --- a/lib/mdi/Install.py +++ b/lib/mdi/Install.py @@ -177,7 +177,7 @@ try: except: n_cpus = 1 -print("Building lib%s.so ..." % lib) +print("Building lib%s.a ..." % lib) cmd = "make -f Makefile.auto clean; make -f Makefile.auto -j%d" % n_cpus txt = subprocess.check_output(cmd,shell=True,stderr=subprocess.STDOUT) print(txt.decode('UTF-8')) @@ -201,10 +201,10 @@ makefile_lammps.write(str(rpath_option) + "\n") makefile_lammps.close() -shared_files = glob.glob( os.path.join( homepath, "liblink", "lib%s.so*" % lib) ) +shared_files = glob.glob( os.path.join( homepath, "liblink", "lib%s.a" % lib) ) if len(shared_files) > 0: print("Build was successful") else: - error("Build of lib/%s/lib%s.so was NOT successful" % (lib,lib)) + error("Build of lib/%s/lib%s.a was NOT successful" % (lib,lib)) if has_extramake and not os.path.exists("Makefile.lammps"): print("lib/%s/Makefile.lammps was NOT created" % lib) diff --git a/lib/mdi/Makefile.g++ b/lib/mdi/Makefile.g++ index 15cc9c3a3b..41300f9992 100644 --- a/lib/mdi/Makefile.g++ +++ b/lib/mdi/Makefile.g++ @@ -8,7 +8,7 @@ EXTRAMAKE = Makefile.lammps.empty lib: $(OBJ) mkdir -p build - cd build; cmake -Dlibtype=SHARED -Dlanguage=CXX -D CMAKE_C_COMPILER=gcc -D CMAKE_CXX_COMPILER=g++ ../MDI_Library; make + cd build; cmake -Dlibtype=STATIC -Dlanguage=C -D CMAKE_POSITION_INDEPENDENT_CODE=yes -D CMAKE_C_COMPILER=gcc -D CMAKE_CXX_COMPILER=g++ ../MDI_Library; make @cp $(EXTRAMAKE) Makefile.lammps # ------ CLEAN ------ diff --git a/lib/mdi/Makefile.gcc b/lib/mdi/Makefile.gcc index a67209202b..023c0e20df 100644 --- a/lib/mdi/Makefile.gcc +++ b/lib/mdi/Makefile.gcc @@ -8,7 +8,7 @@ EXTRAMAKE = Makefile.lammps.empty lib: $(OBJ) mkdir -p build - cd build; cmake -Dlibtype=SHARED -D CMAKE_C_COMPILER=gcc ../MDI_Library; make + cd build; cmake -Dlibtype=STATIC -Dlanguage=C -D CMAKE_POSITION_INDEPENDENT_CODE=yes -D CMAKE_C_COMPILER=gcc ../MDI_Library; make @cp $(EXTRAMAKE) Makefile.lammps # ------ CLEAN ------ diff --git a/lib/mdi/Makefile.icc b/lib/mdi/Makefile.icc index eac6ba087f..8c5049561b 100644 --- a/lib/mdi/Makefile.icc +++ b/lib/mdi/Makefile.icc @@ -8,7 +8,7 @@ EXTRAMAKE = Makefile.lammps.empty lib: $(OBJ) mkdir -p build - cd build; cmake -Dlibtype=SHARED -D CMAKE_C_COMPILER=icc -D CMAKE_CXX_COMPILER=icc ../MDI_Library; make + cd build; cmake -Dlibtype=STATIC -Dlanguage=C -D CMAKE_POSITION_INDEPENDENT_CODE=yes -D CMAKE_C_COMPILER=icc -D CMAKE_CXX_COMPILER=icpc ../MDI_Library; make @cp $(EXTRAMAKE) Makefile.lammps # ------ CLEAN ------ diff --git a/lib/mdi/Makefile.mpi b/lib/mdi/Makefile.mpi index 0a40520c95..ce40bc9d4d 100644 --- a/lib/mdi/Makefile.mpi +++ b/lib/mdi/Makefile.mpi @@ -8,7 +8,7 @@ EXTRAMAKE = Makefile.lammps.empty lib: $(OBJ) mkdir -p build - cd build; cmake -Dlibtype=SHARED -D CMAKE_C_COMPILER=mpicc -D CMAKE_CXX_COMPILER=mpicxx ../MDI_Library; make + cd build; cmake -Dlibtype=STATIC -Dlanguage=C -D CMAKE_POSITION_INDEPENDENT_CODE=yes -D CMAKE_C_COMPILER=mpicc -D CMAKE_CXX_COMPILER=mpicxx ../MDI_Library; make @cp $(EXTRAMAKE) Makefile.lammps # ------ CLEAN ------ From 6549ba16bf49625ffa54d8a1be19077642660052 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Tue, 28 Jun 2022 13:35:49 -0600 Subject: [PATCH 461/585] debugging of dipole iterations --- examples/amoeba/in.water_box.amoeba | 4 ++-- examples/amoeba/in.water_box.hippo | 4 ++-- src/AMOEBA/amoeba_induce.cpp | 8 +++++++ src/AMOEBA/pair_amoeba.cpp | 35 ++++++++++++++++++++++++++++- 4 files changed, 46 insertions(+), 5 deletions(-) diff --git a/examples/amoeba/in.water_box.amoeba b/examples/amoeba/in.water_box.amoeba index 9c46f9d5c8..be21af5f9a 100644 --- a/examples/amoeba/in.water_box.amoeba +++ b/examples/amoeba/in.water_box.amoeba @@ -43,5 +43,5 @@ dump_modify 1 sort id fix 1 all nve -thermo 10 -run 100 +thermo 1 +run 5 diff --git a/examples/amoeba/in.water_box.hippo b/examples/amoeba/in.water_box.hippo index ec1cc1cc78..03d8118eb4 100644 --- a/examples/amoeba/in.water_box.hippo +++ b/examples/amoeba/in.water_box.hippo @@ -43,5 +43,5 @@ dump_modify 1 sort id fix 1 all nve -thermo 10 -run 100 +thermo 1 +run 5 diff --git a/src/AMOEBA/amoeba_induce.cpp b/src/AMOEBA/amoeba_induce.cpp index 884ba71edf..ec9cd1f1d3 100644 --- a/src/AMOEBA/amoeba_induce.cpp +++ b/src/AMOEBA/amoeba_induce.cpp @@ -25,6 +25,10 @@ #include "memory.h" #include "error.h" +// DEBUG + +#include "update.h" + #include #include @@ -381,6 +385,10 @@ void PairAmoeba::induce() } } + // DEBUG + + printf("CG iteration count = %d\n",iter); + // terminate the calculation if dipoles failed to converge // NOTE: could make this an error diff --git a/src/AMOEBA/pair_amoeba.cpp b/src/AMOEBA/pair_amoeba.cpp index 1c17e3b2ae..afd134d8e6 100644 --- a/src/AMOEBA/pair_amoeba.cpp +++ b/src/AMOEBA/pair_amoeba.cpp @@ -1756,7 +1756,10 @@ void PairAmoeba::precond_neigh() choose(USOLV); //double off = sqrt(off2); + //if (comm->me == 0) printf("PCN off %g off2 %g\n",off,off2); //off2 = (off + neighbor->skin) * (off + neighbor->skin); + //if (comm->me == 0) + // printf("PCNnew off %g off2 %g skin %g\n",sqrt(off2),off2,neighbor->skin); // atoms and neighbor list @@ -1770,6 +1773,13 @@ void PairAmoeba::precond_neigh() // store all induce neighs of owned atoms within shorter cutoff // scan longer-cutoff neighbor list of I + + // DEBUG + + int *ncount; + memory->create(ncount,atom->nlocal,"amoeba:ncount"); + for (int i = 0; i < atom->nlocal; i++) ncount[i] = 0; + ipage_precond->reset(); for (ii = 0; ii < inum; ii++) { @@ -1793,15 +1803,38 @@ void PairAmoeba::precond_neigh() delz = ztmp - x[j][2]; rsq = delx*delx + dely*dely + delz*delz; - if (rsq < off2) neighptr[n++] = jlist[jj]; + if (rsq < off2) { + neighptr[n++] = jlist[jj]; + + // DEBUG + + int jcount = atom->map(atom->tag[j]); + ncount[jcount]++; + } } firstneigh_precond[i] = neighptr; numneigh_precond[i] = n; ipage_precond->vgot(n); + + // DEBUG + + ncount[i] += n; } + + // DEBUG + + if (update->ntimestep == 0) { + for (int i = 1; i <= atom->nlocal; i++) { + int ilocal = atom->map(i); + printf("PRECOND id %d ilocal %d numneigh %d\n",i,ilocal,ncount[ilocal]); + } + } + + memory->destroy(ncount); } + /* ---------------------------------------------------------------------- allocate Vdwl arrays note that n_amclass = # of classes in Tinker PRM file From 1fe7fdc7d6ffa2dc8c7108b1cca270c4f39728d4 Mon Sep 17 00:00:00 2001 From: Stan Moore Date: Tue, 28 Jun 2022 15:04:10 -0600 Subject: [PATCH 462/585] Add more missing Kokkos data movement --- src/KOKKOS/min_kokkos.cpp | 3 ++- 1 file changed, 2 insertions(+), 1 deletion(-) diff --git a/src/KOKKOS/min_kokkos.cpp b/src/KOKKOS/min_kokkos.cpp index 9aebd80d2e..a590409c49 100644 --- a/src/KOKKOS/min_kokkos.cpp +++ b/src/KOKKOS/min_kokkos.cpp @@ -499,6 +499,7 @@ double MinKokkos::energy_force(int resetflag) if (force->newton) { comm->reverse_comm(); timer->stamp(Timer::COMM); + atomKK->sync(Device,F_MASK); } // update per-atom minimization variables stored by pair styles @@ -571,7 +572,7 @@ void MinKokkos::force_clear() } }); } - atomKK->modified(Device,F_MASK); + atomKK->modified(Device,F_MASK|TORQUE_MASK); } /* ---------------------------------------------------------------------- From ae235b1ef5a59da3bb5f4e2a83f40ab8072a0598 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Tue, 28 Jun 2022 16:19:06 -0600 Subject: [PATCH 463/585] Boolean expression corner case --- src/variable.cpp | 6 +++++- 1 file changed, 5 insertions(+), 1 deletion(-) diff --git a/src/variable.cpp b/src/variable.cpp index 7392379017..bcb42f0599 100644 --- a/src/variable.cpp +++ b/src/variable.cpp @@ -4775,7 +4775,7 @@ double Variable::evaluate_boolean(char *str) else argstack[nargstack].value = 0.0; } else if (opprevious == EQ) { if (flag1 != flag2) - error->all(FLERR,"Invalid Boolean syntax in if command"); + error->all(FLERR,"If command boolean comparing string to number"); if (flag2 == 0) { if (value1 == value2) argstack[nargstack].value = 1.0; else argstack[nargstack].value = 0.0; @@ -4845,6 +4845,10 @@ double Variable::evaluate_boolean(char *str) if (nopstack) error->all(FLERR,"Invalid Boolean syntax in if command"); if (nargstack != 1) error->all(FLERR,"Invalid Boolean syntax in if command"); + + // if flag == 1, Boolean expression was a single string with no operator + + if (argstack[0].flag == 1) return 0.0; return argstack[0].value; } From 4a2182ae84a64e8c29b763f1afc75549470f326b Mon Sep 17 00:00:00 2001 From: jkelowitt <58435724+jkelowitt@users.noreply.github.com> Date: Tue, 28 Jun 2022 16:22:25 -0600 Subject: [PATCH 464/585] Rename threebody_on to threebody_flag --- src/MANYBODY/pair_sw.cpp | 8 ++++---- src/MANYBODY/pair_sw.h | 10 +++++----- src/OPENMP/pair_sw_omp.cpp | 2 +- 3 files changed, 10 insertions(+), 10 deletions(-) diff --git a/src/MANYBODY/pair_sw.cpp b/src/MANYBODY/pair_sw.cpp index 9188b98ae9..0564f9be2b 100644 --- a/src/MANYBODY/pair_sw.cpp +++ b/src/MANYBODY/pair_sw.cpp @@ -159,7 +159,7 @@ void PairSW::compute(int eflag, int vflag) if (evflag) ev_tally(i,j,nlocal,newton_pair, evdwl,0.0,fpair,delx,dely,delz); } - if (threebody_on) { + if (threebody_flag) { jnumm1 = numshort - 1; for (jj = 0; jj < jnumm1; jj++) { @@ -233,7 +233,7 @@ void PairSW::allocate() void PairSW::settings(int narg, char ** arg) { // Default - threebody_on = true; + threebody_flag = true; int iarg = 0; @@ -241,10 +241,10 @@ void PairSW::settings(int narg, char ** arg) if (strcmp(arg[iarg],"threebody") == 0) { if (iarg+2 > narg) error->all(FLERR,"Illegal pair_style command"); if (strcmp(arg[iarg+1], "on") == 0) { - threebody_on = true; + threebody_flag = true; one_coeff = 1; } else if (strcmp(arg[iarg+1], "off") == 0) { - threebody_on = false; + threebody_flag = false; one_coeff = 0; // Allow for multiple pair_coeff's } else error->all(FLERR,"Illegal pair_style command"); iarg += 2; diff --git a/src/MANYBODY/pair_sw.h b/src/MANYBODY/pair_sw.h index 34fbfa4a4a..76d1bbc202 100644 --- a/src/MANYBODY/pair_sw.h +++ b/src/MANYBODY/pair_sw.h @@ -48,11 +48,11 @@ class PairSW : public Pair { }; protected: - double cutmax; // max cutoff for all elements - Param *params; // parameter set for an I-J-K interaction - int maxshort; // size of short neighbor list array - int *neighshort; // short neighbor list array - bool threebody_on; // whether to run threebody loop + double cutmax; // max cutoff for all elements + Param *params; // parameter set for an I-J-K interaction + int maxshort; // size of short neighbor list array + int *neighshort; // short neighbor list array + bool threebody_flag; // whether to run threebody loop void settings(int, char **) override; virtual void allocate(); diff --git a/src/OPENMP/pair_sw_omp.cpp b/src/OPENMP/pair_sw_omp.cpp index 32df823e31..a1c0bec34c 100644 --- a/src/OPENMP/pair_sw_omp.cpp +++ b/src/OPENMP/pair_sw_omp.cpp @@ -156,7 +156,7 @@ void PairSWOMP::eval(int iifrom, int iito, ThrData * const thr) if (EVFLAG) ev_tally_thr(this,i,j,nlocal,/* newton_pair */ 1, evdwl,0.0,fpair,delx,dely,delz,thr); } - if (threebody_on) { + if (threebody_flag) { jnumm1 = numshort - 1; for (jj = 0; jj < jnumm1; jj++) { From e8c2dcc693f1f0a46a02dd989de2e35e56cd5119 Mon Sep 17 00:00:00 2001 From: jkelowitt <58435724+jkelowitt@users.noreply.github.com> Date: Tue, 28 Jun 2022 16:25:35 -0600 Subject: [PATCH 465/585] Fix doc example and doc note. --- doc/src/pair_sw.rst | 7 ++++--- 1 file changed, 4 insertions(+), 3 deletions(-) diff --git a/doc/src/pair_sw.rst b/doc/src/pair_sw.rst index a249856371..4f51be7a6a 100644 --- a/doc/src/pair_sw.rst +++ b/doc/src/pair_sw.rst @@ -49,8 +49,9 @@ Examples pair_coeff * * tmd.sw.mod Mo S S pair_style hybrid sw sw threebody off - pair_coeff * * mW_xL.sw mW NULL - pair_coeff * 2 mW_xL.sw mW xL + pair_coeff * * sw 1 mW_xL.sw mW NULL + pair_coeff 1 2 sw 2 mW_xL.sw mW xL + pair_coeff 2 2 sw 2 mW_xL.sw mW xL Description """"""""""" @@ -154,7 +155,7 @@ potentials. .. note:: - When the *threebody on* keyword is used, multiple pair_coeff commands may + When the *threebody off* keyword is used, multiple pair_coeff commands may be used to specific the pairs of atoms which don't require three-body term. In these cases, the first 2 arguments are not required to be \* \*. From e4e9b2e49ada676f19ffc63f962e4fbaa10ef940 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Tue, 28 Jun 2022 16:37:04 -0600 Subject: [PATCH 466/585] more consistency checks --- doc/src/if.rst | 32 ++++++++++++++++++++------------ src/variable.cpp | 31 ++++++++++++++++++++----------- 2 files changed, 40 insertions(+), 23 deletions(-) diff --git a/doc/src/if.rst b/doc/src/if.rst index 08ec6f2c3e..2125e2f9a9 100644 --- a/doc/src/if.rst +++ b/doc/src/if.rst @@ -156,27 +156,28 @@ and Boolean operators: Each A and B is a number or string or a variable reference like $a or ${abc}, or A or B can be another Boolean expression. -If a variable is used it can produce a number when evaluated, like an -:doc:`equal-style variable `. Or it can produce a string, -like an :doc:`index-style variable `. For an individual -Boolean operator, A and B must both be numbers or must both be -strings. You cannot compare a number to a string. +Note that all variables used will be substituted for before the +Boolean expression in evaluated. A variable can produce a number, +like an :doc:`equal-style variable `. Or it can produce a +string, like an :doc:`index-style variable `. + +The Boolean operators "==" and "!=" can operate on a pair or strings +or numbers. They cannot compare a number to a string. All the other +Boolean operations can only operate on numbers. Expressions are evaluated left to right and have the usual C-style precedence: the unary logical NOT operator "!" has the highest precedence, the 4 relational operators "<", "<=", ">", and ">=" are next; the two remaining relational operators "==" and "!=" are next; then the logical AND operator "&&"; and finally the logical OR -operator "\|\|" and logical XOR (exclusive or) operator "\|\^" have the -lowest precedence. Parenthesis can be used to group one or more +operator "\|\|" and logical XOR (exclusive or) operator "\|\^" have +the lowest precedence. Parenthesis can be used to group one or more portions of an expression and/or enforce a different order of evaluation than what would occur with the default precedence. When the 6 relational operators (first 6 in list above) compare 2 numbers, they return either a 1.0 or 0.0 depending on whether the -relationship between A and B is TRUE or FALSE. When the 6 relational -operators compare 2 strings, they also return a 1.0 or 0.0 for TRUE or -FALSE, but the comparison is done by the C function strcmp(). +relationship between A and B is TRUE or FALSE. When the 3 logical operators (last 3 in list above) compare 2 numbers, they also return either a 1.0 or 0.0 depending on whether the @@ -190,8 +191,15 @@ returns 1.0 if its argument is 0.0, else it returns 0.0. The 3 logical operators can only be used to operate on numbers, not on strings. -The overall Boolean expression produces a TRUE result if the result is -non-zero. If the result is zero, the expression result is FALSE. +The overall Boolean expression produces a TRUE result if the numeric +result is non-zero. If the result is zero, the expression result is +FALSE. + +.. note:: + + If the Boolean expression is a single numeric value with no Boolean + operators, it will be FALSE if the value = 0.0, otherwise TRUE. If the + Boolean expression is a single string, it will always be FALSE. ---------- diff --git a/src/variable.cpp b/src/variable.cpp index bcb42f0599..9afc4d5c6a 100644 --- a/src/variable.cpp +++ b/src/variable.cpp @@ -4770,12 +4770,14 @@ double Variable::evaluate_boolean(char *str) } if (opprevious == NOT) { - if (flag2) error->all(FLERR,"Invalid Boolean syntax in if command"); + if (flag2) + error->all(FLERR,"If command boolean not cannot operate on string"); if (value2 == 0.0) argstack[nargstack].value = 1.0; else argstack[nargstack].value = 0.0; + } else if (opprevious == EQ) { if (flag1 != flag2) - error->all(FLERR,"If command boolean comparing string to number"); + error->all(FLERR,"If command boolean is comparing string to number"); if (flag2 == 0) { if (value1 == value2) argstack[nargstack].value = 1.0; else argstack[nargstack].value = 0.0; @@ -4787,7 +4789,7 @@ double Variable::evaluate_boolean(char *str) } } else if (opprevious == NE) { if (flag1 != flag2) - error->all(FLERR,"Invalid Boolean syntax in if command"); + error->all(FLERR,"If command boolean is comparing string to number"); if (flag2 == 0) { if (value1 != value2) argstack[nargstack].value = 1.0; else argstack[nargstack].value = 0.0; @@ -4797,32 +4799,39 @@ double Variable::evaluate_boolean(char *str) delete[] str1; delete[] str2; } + } else if (opprevious == LT) { - if (flag2) error->all(FLERR,"Invalid Boolean syntax in if command"); - if (value1 < value2) argstack[nargstack].value = 1.0; + if (flag1 || flag2) + error->all(FLERR,"If command boolean can only operate on numbers"); else argstack[nargstack].value = 0.0; } else if (opprevious == LE) { - if (flag2) error->all(FLERR,"Invalid Boolean syntax in if command"); + if (flag1 || flag2) + error->all(FLERR,"If command boolean can only operate on numbers"); if (value1 <= value2) argstack[nargstack].value = 1.0; else argstack[nargstack].value = 0.0; } else if (opprevious == GT) { - if (flag2) error->all(FLERR,"Invalid Boolean syntax in if command"); + if (flag1 || flag2) + error->all(FLERR,"If command boolean can only operate on numbers"); if (value1 > value2) argstack[nargstack].value = 1.0; else argstack[nargstack].value = 0.0; } else if (opprevious == GE) { - if (flag2) error->all(FLERR,"Invalid Boolean syntax in if command"); + if (flag1 || flag2) + error->all(FLERR,"If command boolean can only operate on numbers"); if (value1 >= value2) argstack[nargstack].value = 1.0; else argstack[nargstack].value = 0.0; } else if (opprevious == AND) { - if (flag2) error->all(FLERR,"Invalid Boolean syntax in if command"); + if (flag1 || flag2) + error->all(FLERR,"If command boolean can only operate on numbers"); if (value1 != 0.0 && value2 != 0.0) argstack[nargstack].value = 1.0; else argstack[nargstack].value = 0.0; } else if (opprevious == OR) { - if (flag2) error->all(FLERR,"Invalid Boolean syntax in if command"); + if (flag1 || flag2) + error->all(FLERR,"If command boolean can only operate on numbers"); if (value1 != 0.0 || value2 != 0.0) argstack[nargstack].value = 1.0; else argstack[nargstack].value = 0.0; } else if (opprevious == XOR) { - if (flag2) error->all(FLERR,"Invalid Boolean syntax in if command"); + if (flag1 || flag2) + error->all(FLERR,"If command boolean can only operate on numbers"); if ((value1 == 0.0 && value2 != 0.0) || (value1 != 0.0 && value2 == 0.0)) argstack[nargstack].value = 1.0; From 1dc71ef3e344beee9aa861babc9c21d237e23313 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Tue, 28 Jun 2022 16:38:51 -0600 Subject: [PATCH 467/585] better error strings --- src/variable.cpp | 1 + 1 file changed, 1 insertion(+) diff --git a/src/variable.cpp b/src/variable.cpp index 9afc4d5c6a..502d4d3312 100644 --- a/src/variable.cpp +++ b/src/variable.cpp @@ -4819,6 +4819,7 @@ double Variable::evaluate_boolean(char *str) error->all(FLERR,"If command boolean can only operate on numbers"); if (value1 >= value2) argstack[nargstack].value = 1.0; else argstack[nargstack].value = 0.0; + } else if (opprevious == AND) { if (flag1 || flag2) error->all(FLERR,"If command boolean can only operate on numbers"); From 4db7f91c4805b472bde3205ea012cb78a3a36d75 Mon Sep 17 00:00:00 2001 From: jkelowitt <58435724+jkelowitt@users.noreply.github.com> Date: Tue, 28 Jun 2022 16:52:57 -0600 Subject: [PATCH 468/585] Use utils::logical() to parse arguments. --- src/MANYBODY/pair_sw.cpp | 9 ++------- src/MANYBODY/pair_sw.h | 10 +++++----- 2 files changed, 7 insertions(+), 12 deletions(-) diff --git a/src/MANYBODY/pair_sw.cpp b/src/MANYBODY/pair_sw.cpp index 0564f9be2b..4d6080c146 100644 --- a/src/MANYBODY/pair_sw.cpp +++ b/src/MANYBODY/pair_sw.cpp @@ -240,13 +240,8 @@ void PairSW::settings(int narg, char ** arg) while (iarg < narg) { if (strcmp(arg[iarg],"threebody") == 0) { if (iarg+2 > narg) error->all(FLERR,"Illegal pair_style command"); - if (strcmp(arg[iarg+1], "on") == 0) { - threebody_flag = true; - one_coeff = 1; - } else if (strcmp(arg[iarg+1], "off") == 0) { - threebody_flag = false; - one_coeff = 0; // Allow for multiple pair_coeff's - } else error->all(FLERR,"Illegal pair_style command"); + threebody_flag = utils::logical(FLERR,arg[iarg+1],false,lmp); + one_coeff = threebody_flag; iarg += 2; } else error->all(FLERR,"Illegal pair_style command"); } diff --git a/src/MANYBODY/pair_sw.h b/src/MANYBODY/pair_sw.h index 76d1bbc202..40d3568fb4 100644 --- a/src/MANYBODY/pair_sw.h +++ b/src/MANYBODY/pair_sw.h @@ -48,11 +48,11 @@ class PairSW : public Pair { }; protected: - double cutmax; // max cutoff for all elements - Param *params; // parameter set for an I-J-K interaction - int maxshort; // size of short neighbor list array - int *neighshort; // short neighbor list array - bool threebody_flag; // whether to run threebody loop + double cutmax; // max cutoff for all elements + Param *params; // parameter set for an I-J-K interaction + int maxshort; // size of short neighbor list array + int *neighshort; // short neighbor list array + int threebody_flag; // whether to run threebody loop void settings(int, char **) override; virtual void allocate(); From 9a05cd3e983ef33edfdfba6a625872f13472ede7 Mon Sep 17 00:00:00 2001 From: jkelowitt <58435724+jkelowitt@users.noreply.github.com> Date: Tue, 28 Jun 2022 16:59:32 -0600 Subject: [PATCH 469/585] Fix gramatical errors --- doc/src/pair_sw.rst | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/doc/src/pair_sw.rst b/doc/src/pair_sw.rst index 4f51be7a6a..5a4e8f4c38 100644 --- a/doc/src/pair_sw.rst +++ b/doc/src/pair_sw.rst @@ -33,7 +33,7 @@ Syntax delta2 = The maximum threshold for the variation of cosine of three-body angle *threebody* value = *on* or *off* (optional) on (default) = Compute both the three-body and two-body terms of the potential - off = Compute both only the two-body terms of the potential + off = Compute only the two-body term of the potential Examples From 8d272db37a5f1eeacde71ad3a1bac58c811915fb Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 29 Jun 2022 05:14:04 -0400 Subject: [PATCH 470/585] whitespace --- src/KOKKOS/min_linesearch_kokkos.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/KOKKOS/min_linesearch_kokkos.cpp b/src/KOKKOS/min_linesearch_kokkos.cpp index cb97a34e50..76ea522fa8 100644 --- a/src/KOKKOS/min_linesearch_kokkos.cpp +++ b/src/KOKKOS/min_linesearch_kokkos.cpp @@ -363,7 +363,7 @@ double MinLineSearchKokkos::alpha_step(double alpha, int resetflag) // reset to starting point if (nextra_global) modify->min_step(0.0,hextra); - atomKK->k_x.clear_sync_state(); // ignore if host positions modified since + atomKK->k_x.clear_sync_state(); // ignore if host positions modified since // device positions will be reset below { // local variables for lambda capture From 1fabd5a56b62637d9f7070956952611689229b3b Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Wed, 29 Jun 2022 07:49:22 -0600 Subject: [PATCH 471/585] change boolean = single string to an error --- doc/src/if.rst | 5 +++-- src/variable.cpp | 5 ++++- 2 files changed, 7 insertions(+), 3 deletions(-) diff --git a/doc/src/if.rst b/doc/src/if.rst index 2125e2f9a9..91b001fbdc 100644 --- a/doc/src/if.rst +++ b/doc/src/if.rst @@ -198,8 +198,9 @@ FALSE. .. note:: If the Boolean expression is a single numeric value with no Boolean - operators, it will be FALSE if the value = 0.0, otherwise TRUE. If the - Boolean expression is a single string, it will always be FALSE. + operators, it will be FALSE if the value = 0.0, otherwise TRUE. If + the Boolean expression is a single string, an error message will be + issued. ---------- diff --git a/src/variable.cpp b/src/variable.cpp index 502d4d3312..31187f69dc 100644 --- a/src/variable.cpp +++ b/src/variable.cpp @@ -4857,8 +4857,11 @@ double Variable::evaluate_boolean(char *str) if (nargstack != 1) error->all(FLERR,"Invalid Boolean syntax in if command"); // if flag == 1, Boolean expression was a single string with no operator + // error b/c invalid, only single number with no operator is allowed + + if (argstack[0].flag == 1) + error->all(FLERR,"If command boolean cannot be single string"); - if (argstack[0].flag == 1) return 0.0; return argstack[0].value; } From 793069d8eb240c028578ef8e6c508dc09dddda79 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 29 Jun 2022 12:24:43 -0400 Subject: [PATCH 472/585] update and expand unit tests for if() command boolean evaluation --- unittest/commands/test_variables.cpp | 24 ++++++++++++++++++++++-- 1 file changed, 22 insertions(+), 2 deletions(-) diff --git a/unittest/commands/test_variables.cpp b/unittest/commands/test_variables.cpp index 0533de7329..35bab69c7d 100644 --- a/unittest/commands/test_variables.cpp +++ b/unittest/commands/test_variables.cpp @@ -389,6 +389,8 @@ TEST_F(VariableTest, IfCommand) { BEGIN_HIDE_OUTPUT(); command("variable one index 1"); + command("variable two string xx"); + command("variable three equal 1"); END_HIDE_OUTPUT(); BEGIN_CAPTURE_OUTPUT(); @@ -444,7 +446,11 @@ TEST_F(VariableTest, IfCommand) BEGIN_CAPTURE_OUTPUT(); command("if x!=x|^a!=b then 'print \"bingo!\"'"); text = END_CAPTURE_OUTPUT(); + ASSERT_THAT(text, ContainsRegex(".*bingo!.*")); + BEGIN_CAPTURE_OUTPUT(); + command("if (${three}) then 'print \"bingo!\"'"); + text = END_CAPTURE_OUTPUT(); ASSERT_THAT(text, ContainsRegex(".*bingo!.*")); TEST_FAILURE(".*ERROR: Invalid Boolean syntax in if command.*", @@ -455,8 +461,16 @@ TEST_F(VariableTest, IfCommand) command("if 1a then 'print \"bingo!\"'");); TEST_FAILURE(".*ERROR: Invalid Boolean syntax in if command.*", command("if 1=<2 then 'print \"bingo!\"'");); - TEST_FAILURE(".*ERROR: Invalid Boolean syntax in if command.*", + TEST_FAILURE(".*ERROR: If command boolean is comparing string to number.*", command("if 1!=a then 'print \"bingo!\"'");); + TEST_FAILURE(".*ERROR: If command boolean can only operate on numbers.*", + command("if ab then 'print \"bingo!\"'");); + TEST_FAILURE(".*ERROR: If command boolean can only operate on numbers.*", + command("if a<=b then 'print \"bingo!\"'");); + TEST_FAILURE(".*ERROR: If command boolean can only operate on numbers.*", + command("if a<=b then 'print \"bingo!\"'");); TEST_FAILURE(".*ERROR: Invalid Boolean syntax in if command.*", command("if 1&<2 then 'print \"bingo!\"'");); TEST_FAILURE(".*ERROR: Invalid Boolean syntax in if command.*", @@ -465,8 +479,14 @@ TEST_F(VariableTest, IfCommand) command("if (1)( then 'print \"bingo!\"'");); TEST_FAILURE(".*ERROR: Invalid Boolean syntax in if command.*", command("if (1)1 then 'print \"bingo!\"'");); - TEST_FAILURE(".*ERROR: Invalid Boolean syntax in if command.*", + TEST_FAILURE(".*ERROR: If command boolean is comparing string to number.*", command("if (v_one==1.0)&&(2>=1) then 'print \"bingo!\"'");); + TEST_FAILURE(".*ERROR: If command boolean cannot be single string.*", + command("if (something) then 'print \"bingo!\"'");); + TEST_FAILURE(".*ERROR: If command boolean cannot be single string.*", + command("if (v_one) then 'print \"bingo!\"'");); + TEST_FAILURE(".*ERROR: If command boolean cannot be single string.*", + command("if (${two}) then 'print \"bingo!\"'");); } TEST_F(VariableTest, NextCommand) From 137dc6243e6817058698f0e1cec3f61172ad1f24 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 29 Jun 2022 12:25:15 -0400 Subject: [PATCH 473/585] whitespace --- src/variable.cpp | 18 +++++++++--------- 1 file changed, 9 insertions(+), 9 deletions(-) diff --git a/src/variable.cpp b/src/variable.cpp index 31187f69dc..1c94356186 100644 --- a/src/variable.cpp +++ b/src/variable.cpp @@ -4770,7 +4770,7 @@ double Variable::evaluate_boolean(char *str) } if (opprevious == NOT) { - if (flag2) + if (flag2) error->all(FLERR,"If command boolean not cannot operate on string"); if (value2 == 0.0) argstack[nargstack].value = 1.0; else argstack[nargstack].value = 0.0; @@ -4801,37 +4801,37 @@ double Variable::evaluate_boolean(char *str) } } else if (opprevious == LT) { - if (flag1 || flag2) + if (flag1 || flag2) error->all(FLERR,"If command boolean can only operate on numbers"); else argstack[nargstack].value = 0.0; } else if (opprevious == LE) { - if (flag1 || flag2) + if (flag1 || flag2) error->all(FLERR,"If command boolean can only operate on numbers"); if (value1 <= value2) argstack[nargstack].value = 1.0; else argstack[nargstack].value = 0.0; } else if (opprevious == GT) { - if (flag1 || flag2) + if (flag1 || flag2) error->all(FLERR,"If command boolean can only operate on numbers"); if (value1 > value2) argstack[nargstack].value = 1.0; else argstack[nargstack].value = 0.0; } else if (opprevious == GE) { - if (flag1 || flag2) + if (flag1 || flag2) error->all(FLERR,"If command boolean can only operate on numbers"); if (value1 >= value2) argstack[nargstack].value = 1.0; else argstack[nargstack].value = 0.0; } else if (opprevious == AND) { - if (flag1 || flag2) + if (flag1 || flag2) error->all(FLERR,"If command boolean can only operate on numbers"); if (value1 != 0.0 && value2 != 0.0) argstack[nargstack].value = 1.0; else argstack[nargstack].value = 0.0; } else if (opprevious == OR) { - if (flag1 || flag2) + if (flag1 || flag2) error->all(FLERR,"If command boolean can only operate on numbers"); if (value1 != 0.0 || value2 != 0.0) argstack[nargstack].value = 1.0; else argstack[nargstack].value = 0.0; } else if (opprevious == XOR) { - if (flag1 || flag2) + if (flag1 || flag2) error->all(FLERR,"If command boolean can only operate on numbers"); if ((value1 == 0.0 && value2 != 0.0) || (value1 != 0.0 && value2 == 0.0)) @@ -4859,7 +4859,7 @@ double Variable::evaluate_boolean(char *str) // if flag == 1, Boolean expression was a single string with no operator // error b/c invalid, only single number with no operator is allowed - if (argstack[0].flag == 1) + if (argstack[0].flag == 1) error->all(FLERR,"If command boolean cannot be single string"); return argstack[0].value; From f273a28a2a625618c959890395479ca5c339f0a9 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 29 Jun 2022 12:26:16 -0400 Subject: [PATCH 474/585] whitespace --- src/KOKKOS/min_linesearch_kokkos.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/KOKKOS/min_linesearch_kokkos.cpp b/src/KOKKOS/min_linesearch_kokkos.cpp index cb97a34e50..76ea522fa8 100644 --- a/src/KOKKOS/min_linesearch_kokkos.cpp +++ b/src/KOKKOS/min_linesearch_kokkos.cpp @@ -363,7 +363,7 @@ double MinLineSearchKokkos::alpha_step(double alpha, int resetflag) // reset to starting point if (nextra_global) modify->min_step(0.0,hextra); - atomKK->k_x.clear_sync_state(); // ignore if host positions modified since + atomKK->k_x.clear_sync_state(); // ignore if host positions modified since // device positions will be reset below { // local variables for lambda capture From 8d8f7983fb92f72842e881152dd5ff51c31c3d75 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 29 Jun 2022 16:45:11 -0400 Subject: [PATCH 475/585] fix bug in recent bugfix --- src/variable.cpp | 1 + 1 file changed, 1 insertion(+) diff --git a/src/variable.cpp b/src/variable.cpp index 1c94356186..878066f466 100644 --- a/src/variable.cpp +++ b/src/variable.cpp @@ -4803,6 +4803,7 @@ double Variable::evaluate_boolean(char *str) } else if (opprevious == LT) { if (flag1 || flag2) error->all(FLERR,"If command boolean can only operate on numbers"); + if (value1 < value2) argstack[nargstack].value = 1.0; else argstack[nargstack].value = 0.0; } else if (opprevious == LE) { if (flag1 || flag2) From 533a56404a275907d269d76a733d21ca4a75a58a Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 29 Jun 2022 16:45:28 -0400 Subject: [PATCH 476/585] add more unit tests for boolean expressions --- unittest/commands/test_variables.cpp | 25 +++++++++++++++++++++++++ 1 file changed, 25 insertions(+) diff --git a/unittest/commands/test_variables.cpp b/unittest/commands/test_variables.cpp index 35bab69c7d..29b985927d 100644 --- a/unittest/commands/test_variables.cpp +++ b/unittest/commands/test_variables.cpp @@ -403,11 +403,36 @@ TEST_F(VariableTest, IfCommand) text = END_CAPTURE_OUTPUT(); ASSERT_THAT(text, ContainsRegex(".*nope\?.*")); + BEGIN_CAPTURE_OUTPUT(); + command("if 0<1 then 'print \"bingo!\"'"); + text = END_CAPTURE_OUTPUT(); + ASSERT_THAT(text, ContainsRegex(".*bingo!.*")); + + BEGIN_CAPTURE_OUTPUT(); + command("if 2<1 then 'print \"bingo!\"' else 'print \"nope?\"'"); + text = END_CAPTURE_OUTPUT(); + ASSERT_THAT(text, ContainsRegex(".*nope\?.*")); + BEGIN_CAPTURE_OUTPUT(); command("if (1<=0) then 'print \"bingo!\"' else 'print \"nope?\"'"); text = END_CAPTURE_OUTPUT(); ASSERT_THAT(text, ContainsRegex(".*nope\?.*")); + BEGIN_CAPTURE_OUTPUT(); + command("if (0<=0) then 'print \"bingo!\"' else 'print \"nope?\"'"); + text = END_CAPTURE_OUTPUT(); + ASSERT_THAT(text, ContainsRegex(".*bingo!.*")); + + BEGIN_CAPTURE_OUTPUT(); + command("if (0>=1) then 'print \"bingo!\"' else 'print \"nope?\"'"); + text = END_CAPTURE_OUTPUT(); + ASSERT_THAT(text, ContainsRegex(".*nope\?.*")); + + BEGIN_CAPTURE_OUTPUT(); + command("if (1>=1) then 'print \"bingo!\"' else 'print \"nope?\"'"); + text = END_CAPTURE_OUTPUT(); + ASSERT_THAT(text, ContainsRegex(".*bingo!.*")); + BEGIN_CAPTURE_OUTPUT(); command("if (-1.0e-1<0.0E+0)|^(1<0) then 'print \"bingo!\"'"); text = END_CAPTURE_OUTPUT(); From 7546955046e60072b13d098a30331a004ad2ea8d Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Wed, 29 Jun 2022 15:10:03 -0600 Subject: [PATCH 477/585] optimizations to input class for reading very long lines --- src/input.cpp | 174 ++++++++++++++++++++++++++++++-------------------- 1 file changed, 104 insertions(+), 70 deletions(-) diff --git a/src/input.cpp b/src/input.cpp index a28bd48296..d40bb55747 100644 --- a/src/input.cpp +++ b/src/input.cpp @@ -188,17 +188,20 @@ of the file is reached. The *infile* pointer will usually point to void Input::file() { - int m,n; + int m,n,mstart,ntriple,endfile; while (true) { // read a line from input script - // n = length of line including str terminator, 0 if end of file + // when done, n = length of line including str terminator, 0 if end of file // if line ends in continuation char '&', concatenate next line + // if triple quotes are used, read until closing triple quotes if (me == 0) { - + ntriple = 0; + endfile = 0; m = 0; + while (true) { if (infile == nullptr) { @@ -206,38 +209,58 @@ void Input::file() break; } - if (maxline-m < 2) reallocate(line,maxline,0); + mstart = m; - // end of file reached, so break - // n == 0 if nothing read, else n = line with str terminator + while (1) { + if (maxline-m < 2) reallocate(line,maxline,0); - if (fgets(&line[m],maxline-m,infile) == nullptr) { - if (m) n = strlen(line) + 1; - else n = 0; + // end of file reached, so break + // n == 0 if nothing read, else n = line with str terminator + + if (fgets(&line[m],maxline-m,infile) == nullptr) { + endfile = 1; + if (m) n = strlen(line) + 1; + else n = 0; + break; + } + + // continue if last char read was not a newline + // can happen if line is very long + + m += strlen(&line[m]); + if (line[m-1] != '\n') continue; break; } - // continue if last char read was not a newline - // could happen if line is very long + if (endfile) break; - m = strlen(line); - if (line[m-1] != '\n') continue; + // add # of triple quotes in just-read line to ntriple - // continue reading if final printable char is & char - // or if odd number of triple quotes - // else break with n = line with str terminator + ntriple += numtriple(&line[mstart]); + + // trim whitespace from end of line + // line[m] = last printable char m--; while (m >= 0 && isspace(line[m])) m--; - if (m < 0 || line[m] != '&') { - if (numtriple(line) % 2) { - m += 2; - continue; - } - line[m+1] = '\0'; - n = m+2; - break; + + // continue reading if final printable char is "&" + + if (m >= 0 && line[m] == '&') continue; + + // continue reading if odd number of triple quotes + + if (ntriple % 2) { + line[m+1] = '\n'; + m += 2; + continue; } + + // done, break with n = length of line with str terminator + + line[m+1] = '\0'; + n = m+2; + break; } } @@ -371,8 +394,9 @@ char *Input::one(const std::string &single) } /* ---------------------------------------------------------------------- - Send text to active echo file pointers + send text to active echo file pointers ------------------------------------------------------------------------- */ + void Input::write_echo(const std::string &txt) { if (me == 0) { @@ -399,34 +423,35 @@ void Input::parse() if (n > maxcopy) reallocate(copy,maxcopy,n); strcpy(copy,line); - // strip any # comment by replacing it with 0 - // do not strip from a # inside single/double/triple quotes - // quoteflag = 1,2,3 when encounter first single/double,triple quote - // quoteflag = 0 when encounter matching single/double,triple quote + // strip a # comment by replacing it with 0 + // do not treat a # inside single/double/triple quotes as a comment - int quoteflag = 0; + char *ptrmatch; char *ptr = copy; + while (*ptr) { - if (*ptr == '#' && !quoteflag) { + if (*ptr == '#') { *ptr = '\0'; break; } - if (quoteflag == 0) { + if (*ptr == '\'') { + ptrmatch = strchr(ptr+1,'\''); + if (ptrmatch == NULL) + error->all(FLERR,"Unmatched single quote in command"); + ptr = ptrmatch + 1; + } else if (*ptr == '"') { if (strstr(ptr,"\"\"\"") == ptr) { - quoteflag = 3; - ptr += 2; + ptrmatch = strstr(ptr+3,"\"\"\""); + if (ptrmatch == NULL) + error->all(FLERR,"Unmatched triple quote in command"); + ptr = ptrmatch + 3; + } else { + ptrmatch = strchr(ptr+1,'"'); + if (ptrmatch == NULL) + error->all(FLERR,"Unmatched double quote in command"); + ptr = ptrmatch + 1; } - else if (*ptr == '"') quoteflag = 2; - else if (*ptr == '\'') quoteflag = 1; - } else { - if (quoteflag == 3 && strstr(ptr,"\"\"\"") == ptr) { - quoteflag = 0; - ptr += 2; - } - else if (quoteflag == 2 && *ptr == '"') quoteflag = 0; - else if (quoteflag == 1 && *ptr == '\'') quoteflag = 0; - } - ptr++; + } else ptr++; } if (utils::has_utf8(copy)) { @@ -534,16 +559,18 @@ void Input::substitute(char *&str, char *&str2, int &max, int &max2, int flag) { // use str2 as scratch space to expand str, then copy back to str // reallocate str and str2 as necessary - // do not replace $ inside single/double/triple quotes + // do not replace variables inside single/double/triple quotes // var = pts at variable name, ended by null char // if $ is followed by '{', trailing '}' becomes null char // else $x becomes x followed by null char // beyond = points to text following variable - int i,n,paren_count; + int i,n,paren_count,nchars;; char immediate[256]; char *var,*value,*beyond; int quoteflag = 0; + char *ptrmatch; + char *ptr = str; n = strlen(str) + 1; @@ -637,34 +664,41 @@ void Input::substitute(char *&str, char *&str2, int &max, int &max2, int flag) if (echo_log && logfile) fprintf(logfile,"%s%s\n",str2,beyond); } - continue; - } + // check for single/double/triple quotes and skip past them - // quoteflag = 1,2,3 when encounter first single/double,triple quote - // quoteflag = 0 when encounter matching single/double,triple quote - // copy 2 extra triple quote chars into str2 - - if (quoteflag == 0) { + } else if (*ptr == '\'') { + ptrmatch = strchr(ptr+1,'\''); + if (ptrmatch == NULL) + error->all(FLERR,"Unmatched single quote in command"); + nchars = ptrmatch+1 - ptr; + strncpy(ptr2,ptr,nchars); + ptr += nchars; + ptr2 += nchars; + } else if (*ptr == '"') { if (strstr(ptr,"\"\"\"") == ptr) { - quoteflag = 3; - *ptr2++ = *ptr++; - *ptr2++ = *ptr++; + ptrmatch = strstr(ptr+3,"\"\"\""); + if (ptrmatch == NULL) + error->all(FLERR,"Unmatched triple quote in command"); + nchars = ptrmatch+3 - ptr; + strncpy(ptr2,ptr,nchars); + ptr += nchars; + ptr2 += nchars; + } else { + ptrmatch = strchr(ptr+1,'"'); + if (ptrmatch == NULL) + error->all(FLERR,"Unmatched double quote in command"); + nchars = ptrmatch+1 - ptr; + strncpy(ptr2,ptr,nchars); + ptr += nchars; + ptr2 += nchars; } - else if (*ptr == '"') quoteflag = 2; - else if (*ptr == '\'') quoteflag = 1; - } else { - if (quoteflag == 3 && strstr(ptr,"\"\"\"") == ptr) { - quoteflag = 0; - *ptr2++ = *ptr++; - *ptr2++ = *ptr++; - } - else if (quoteflag == 2 && *ptr == '"') quoteflag = 0; - else if (quoteflag == 1 && *ptr == '\'') quoteflag = 0; - } - // copy current character into str2 + // else copy current single character into str2 + + } else *ptr2++ = *ptr++; + + // terminate current str2 so variable sub can perform strlen() - *ptr2++ = *ptr++; *ptr2 = '\0'; } From d327a4c512830f6b733be25f0e7801fa70dd678e Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 30 Jun 2022 05:57:52 -0400 Subject: [PATCH 478/585] whitespace --- src/input.cpp | 14 +++++++------- 1 file changed, 7 insertions(+), 7 deletions(-) diff --git a/src/input.cpp b/src/input.cpp index d40bb55747..11e8a53952 100644 --- a/src/input.cpp +++ b/src/input.cpp @@ -226,7 +226,7 @@ void Input::file() // continue if last char read was not a newline // can happen if line is very long - + m += strlen(&line[m]); if (line[m-1] != '\n') continue; break; @@ -436,18 +436,18 @@ void Input::parse() } if (*ptr == '\'') { ptrmatch = strchr(ptr+1,'\''); - if (ptrmatch == NULL) + if (ptrmatch == NULL) error->all(FLERR,"Unmatched single quote in command"); ptr = ptrmatch + 1; } else if (*ptr == '"') { if (strstr(ptr,"\"\"\"") == ptr) { ptrmatch = strstr(ptr+3,"\"\"\""); - if (ptrmatch == NULL) + if (ptrmatch == NULL) error->all(FLERR,"Unmatched triple quote in command"); ptr = ptrmatch + 3; } else { ptrmatch = strchr(ptr+1,'"'); - if (ptrmatch == NULL) + if (ptrmatch == NULL) error->all(FLERR,"Unmatched double quote in command"); ptr = ptrmatch + 1; } @@ -668,7 +668,7 @@ void Input::substitute(char *&str, char *&str2, int &max, int &max2, int flag) } else if (*ptr == '\'') { ptrmatch = strchr(ptr+1,'\''); - if (ptrmatch == NULL) + if (ptrmatch == NULL) error->all(FLERR,"Unmatched single quote in command"); nchars = ptrmatch+1 - ptr; strncpy(ptr2,ptr,nchars); @@ -677,7 +677,7 @@ void Input::substitute(char *&str, char *&str2, int &max, int &max2, int flag) } else if (*ptr == '"') { if (strstr(ptr,"\"\"\"") == ptr) { ptrmatch = strstr(ptr+3,"\"\"\""); - if (ptrmatch == NULL) + if (ptrmatch == NULL) error->all(FLERR,"Unmatched triple quote in command"); nchars = ptrmatch+3 - ptr; strncpy(ptr2,ptr,nchars); @@ -685,7 +685,7 @@ void Input::substitute(char *&str, char *&str2, int &max, int &max2, int flag) ptr2 += nchars; } else { ptrmatch = strchr(ptr+1,'"'); - if (ptrmatch == NULL) + if (ptrmatch == NULL) error->all(FLERR,"Unmatched double quote in command"); nchars = ptrmatch+1 - ptr; strncpy(ptr2,ptr,nchars); From aebf53679e6b28d6cbcee61a2f97094da8d5466b Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Thu, 30 Jun 2022 11:17:13 -0600 Subject: [PATCH 479/585] add Python/MDI info the examples/mdi/README --- examples/mdi/README | 27 +++++++++++++++++++++++---- 1 file changed, 23 insertions(+), 4 deletions(-) diff --git a/examples/mdi/README b/examples/mdi/README index 4976e33f00..6ce83afe94 100644 --- a/examples/mdi/README +++ b/examples/mdi/README @@ -30,9 +30,29 @@ cd src make yes-mdi make mode=shlib mpi -To use the serial_driver.py example you will need Python 3 with Numpy -and mpi4py available in your Python. Make sure LAMMPS and Python are -using same the same version of MPI. +------------------------------------------------- + +Examples 4 and 5 that use Python scripts as MDI drivers. For this you +will need Python 3 with Numpy and mpi4py installed. Make sure LAMMPS +and Python/mpi4py are using same the same version of MPI. + +You will also need MDI installed in your Python. You cannot use the +LAMMPS build of the MDI library for this, b/c LAMMPS builds MDI as a +static library, not shared, which Python requires. + +You can install MDI in your Python via conda: + +% conda install -c conda-forge pymdi=1.4.1 + +or via pip: + +% pip install pymdi==1.4.1 + +It is likely fine to leave off the version number, to get the latest +MDI version. But to be safe, 1.4.1 is the version LAMMPS is currently +using. + +------------------------------------------------- 5 example use-cases are explained below. @@ -40,7 +60,6 @@ In the first 3 examples, results running with MDI should be identical to running without MDI (alone log files). Example #4 has no non-MDI run. Example #5 results should match the non-MDI run of example #1. -------------------------------------------------- ------------------------------------------------- * Example #1 = run ab initio MD (AIMD) From d1d51636a7cf9439606be730f265e7c9b6f22b04 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Thu, 30 Jun 2022 11:19:38 -0600 Subject: [PATCH 480/585] fix typo --- examples/mdi/README | 6 +++--- 1 file changed, 3 insertions(+), 3 deletions(-) diff --git a/examples/mdi/README b/examples/mdi/README index 6ce83afe94..0b74fb9c48 100644 --- a/examples/mdi/README +++ b/examples/mdi/README @@ -32,9 +32,9 @@ make mode=shlib mpi ------------------------------------------------- -Examples 4 and 5 that use Python scripts as MDI drivers. For this you -will need Python 3 with Numpy and mpi4py installed. Make sure LAMMPS -and Python/mpi4py are using same the same version of MPI. +Examples 4 and 5 use Python scripts as MDI drivers. For this you will +need Python 3 with Numpy and mpi4py installed. Make sure LAMMPS and +Python/mpi4py are using same the same version of MPI. You will also need MDI installed in your Python. You cannot use the LAMMPS build of the MDI library for this, b/c LAMMPS builds MDI as a From 025d465ab70050497941265cd3889a55c1d717b2 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Thu, 30 Jun 2022 11:44:31 -0600 Subject: [PATCH 481/585] more debugging on dipole induce --- examples/amoeba/in.ubiquitin | 4 ++-- examples/amoeba/in.water_dimer.amoeba | 4 ++-- examples/amoeba/in.water_dimer.hippo | 4 ++-- examples/amoeba/in.water_hexamer.amoeba | 4 ++-- examples/amoeba/in.water_hexamer.hippo | 4 ++-- src/AMOEBA/pair_amoeba.cpp | 15 +++++++++------ 6 files changed, 19 insertions(+), 16 deletions(-) diff --git a/examples/amoeba/in.ubiquitin b/examples/amoeba/in.ubiquitin index ccbcdec421..a7f540cc52 100644 --- a/examples/amoeba/in.ubiquitin +++ b/examples/amoeba/in.ubiquitin @@ -52,5 +52,5 @@ dump_modify 1 sort id fix 1 all nve -thermo 10 -run 100 +thermo 1 +run 5 diff --git a/examples/amoeba/in.water_dimer.amoeba b/examples/amoeba/in.water_dimer.amoeba index 6e388e9951..47a2edc193 100644 --- a/examples/amoeba/in.water_dimer.amoeba +++ b/examples/amoeba/in.water_dimer.amoeba @@ -43,5 +43,5 @@ dump_modify 1 sort id fix 1 all nve -thermo 10 -run 100 +thermo 1 +run 5 diff --git a/examples/amoeba/in.water_dimer.hippo b/examples/amoeba/in.water_dimer.hippo index 15a7327d5b..21d13512e6 100644 --- a/examples/amoeba/in.water_dimer.hippo +++ b/examples/amoeba/in.water_dimer.hippo @@ -43,5 +43,5 @@ dump_modify 1 sort id fix 1 all nve -thermo 10 -run 100 +thermo 1 +run 5 diff --git a/examples/amoeba/in.water_hexamer.amoeba b/examples/amoeba/in.water_hexamer.amoeba index b96ec3974a..24211065c9 100644 --- a/examples/amoeba/in.water_hexamer.amoeba +++ b/examples/amoeba/in.water_hexamer.amoeba @@ -43,5 +43,5 @@ dump_modify 1 sort id fix 1 all nve -thermo 10 -run 100 +thermo 1 +run 5 diff --git a/examples/amoeba/in.water_hexamer.hippo b/examples/amoeba/in.water_hexamer.hippo index 6e4b40ffa5..c56c938ce8 100644 --- a/examples/amoeba/in.water_hexamer.hippo +++ b/examples/amoeba/in.water_hexamer.hippo @@ -43,5 +43,5 @@ dump_modify 1 sort id fix 1 all nve -thermo 10 -run 100 +thermo 1 +run 5 diff --git a/src/AMOEBA/pair_amoeba.cpp b/src/AMOEBA/pair_amoeba.cpp index afd134d8e6..f5281e964b 100644 --- a/src/AMOEBA/pair_amoeba.cpp +++ b/src/AMOEBA/pair_amoeba.cpp @@ -1751,15 +1751,18 @@ void PairAmoeba::precond_neigh() int *neighptr; // set cutoffs and taper coeffs - // NOTE: add skin to cutoff, same as for main neighbor list ?? + // add skin to cutoff, same as for main neighbor list + // note that Tinker (and thus LAMMPS) does not apply the + // distance cutoff in the CG iterations in induce.cpp, + // all interactions in this skin-extended neigh list are + // used every step until the neighbor list is rebuilt, + // this means the cut+skin distance is not exactly enforced, + // neighbors outside may contribute, neighbors inside may not choose(USOLV); - //double off = sqrt(off2); - //if (comm->me == 0) printf("PCN off %g off2 %g\n",off,off2); - //off2 = (off + neighbor->skin) * (off + neighbor->skin); - //if (comm->me == 0) - // printf("PCNnew off %g off2 %g skin %g\n",sqrt(off2),off2,neighbor->skin); + double off = sqrt(off2); + off2 = (off + neighbor->skin) * (off + neighbor->skin); // atoms and neighbor list From d7c4a495ca56507b65817575c103c42fa68f8ccb Mon Sep 17 00:00:00 2001 From: Jackson Date: Thu, 30 Jun 2022 12:10:17 -0600 Subject: [PATCH 482/585] Force lambda = 0 if threebody_flag is false --- src/MANYBODY/pair_sw.cpp | 2 ++ 1 file changed, 2 insertions(+) diff --git a/src/MANYBODY/pair_sw.cpp b/src/MANYBODY/pair_sw.cpp index 4d6080c146..b75c30c04a 100644 --- a/src/MANYBODY/pair_sw.cpp +++ b/src/MANYBODY/pair_sw.cpp @@ -368,6 +368,8 @@ void PairSW::read_file(char *file) params[nparams].epsilon *= conversion_factor; } + if (!threebody_flag) params[nparams].lambda = 0; + if (params[nparams].epsilon < 0.0 || params[nparams].sigma < 0.0 || params[nparams].littlea < 0.0 || params[nparams].lambda < 0.0 || params[nparams].gamma < 0.0 || params[nparams].biga < 0.0 || From 419460f13b1e2f9fa432c37ca7e3e2444619d9f1 Mon Sep 17 00:00:00 2001 From: Jackson Date: Thu, 30 Jun 2022 13:30:26 -0600 Subject: [PATCH 483/585] Note limitations on threebody in doc --- doc/src/pair_sw.rst | 7 +++++-- 1 file changed, 5 insertions(+), 2 deletions(-) diff --git a/doc/src/pair_sw.rst b/doc/src/pair_sw.rst index 5a4e8f4c38..b33371dce8 100644 --- a/doc/src/pair_sw.rst +++ b/doc/src/pair_sw.rst @@ -120,8 +120,11 @@ This value enables the cut-off function to exclude unnecessary angles in the thr However, the angle variation is much smaller than the given threshold value for actual simulations, so the inconsistency between potential and force can be neglected in actual simulations. -The *threebody* keyword determines whether or not the three-body term of the potential is calculated. Skipping this -significantly increases the speed of the potential, but is only applicable when :math:`\lambda_{ijk} = 0` +The *threebody* keyword determines whether or not the three-body term of the potential is calculated. +Skipping this significantly increases the speed of the calculation, with the tradeoff that :math:\lambda_{ijk} +is forcibly set to 0. If the keyword is used with the pair styles, sw/gpu, sw/intel, or sw/kokkos, +:math:\lambda_{ijk} will still be forcibly set to 0, but no additional benefits will be gained. This keyword +cannot be used for variants of the sw/mod or sw/angle/table pair styles. Only a single pair_coeff command is used with the *sw* and *sw/mod* styles which specifies a Stillinger-Weber potential file with parameters for all From e34e9aca48336071ae01ffe8a891baf79339b6a8 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 30 Jun 2022 15:45:52 -0400 Subject: [PATCH 484/585] improve consistency between CMake and GNU make build. Must explicitly link python when building a static mdi lib --- cmake/Modules/Packages/MDI.cmake | 3 ++- examples/mdi/README | 9 +++++---- lib/mdi/Makefile.g++ | 18 ------------------ lib/mdi/Makefile.gcc | 2 +- lib/mdi/Makefile.icc | 2 +- lib/mdi/Makefile.lammps.empty | 8 +++++--- lib/mdi/Makefile.mpi | 2 +- 7 files changed, 15 insertions(+), 29 deletions(-) delete mode 100644 lib/mdi/Makefile.g++ diff --git a/cmake/Modules/Packages/MDI.cmake b/cmake/Modules/Packages/MDI.cmake index 90188f91a8..1a14d5273a 100644 --- a/cmake/Modules/Packages/MDI.cmake +++ b/cmake/Modules/Packages/MDI.cmake @@ -44,7 +44,7 @@ if(DOWNLOAD_MDI) ExternalProject_Add(mdi_build URL ${MDI_URL} URL_MD5 ${MDI_MD5} - CMAKE_ARGS ${CMAKE_REQUEST_PIC} + CMAKE_ARGS -DCMAKE_INSTALL_PREFIX= -DCMAKE_C_COMPILER=${CMAKE_C_COMPILER} -DCMAKE_BUILD_TYPE=${CMAKE_BUILD_TYPE} @@ -54,6 +54,7 @@ if(DOWNLOAD_MDI) -Dlanguage=C -Dlibtype=STATIC -Dmpi=${MDI_USE_MPI} + -Dplugins=ON -Dpython_plugins=${MDI_USE_PYTHON_PLUGINS} UPDATE_COMMAND "" INSTALL_COMMAND "" diff --git a/examples/mdi/README b/examples/mdi/README index 0b74fb9c48..c6267a7abb 100644 --- a/examples/mdi/README +++ b/examples/mdi/README @@ -2,10 +2,11 @@ These are examples that work the MDI package in LAMMPS which uses the MolSSI MDI library for coupling codes together and communicating between them with MDI messages. -In MDI lingo, one code is the driver and another code is the engine. -The 2 codes can be written in any language; C++ (LAMMPS) and Python -are illustrated here. The 2 codes can each be stand-alone codes, in -which case they can be run on different numbers of processors. The 2 +Within the MDI context, one code is the driver and another code is +the engine. The 2 codes can be written in any language; C++ (LAMMPS) +and Python are illustrated here. The 2 codes can each be stand-alone +codes, in which case they can be run on different numbers of processors. +The 2 codes can communicate either via TCP (sockets) or via MPI. For the TCP case, the driver and engine need to be launched separately, e.g. in 2 windows on your desktop machine. For the MPI case, a single diff --git a/lib/mdi/Makefile.g++ b/lib/mdi/Makefile.g++ deleted file mode 100644 index 41300f9992..0000000000 --- a/lib/mdi/Makefile.g++ +++ /dev/null @@ -1,18 +0,0 @@ -SHELL = /bin/sh - -# which file will be copied to Makefile.lammps - -EXTRAMAKE = Makefile.lammps.empty - -# ------ MAKE PROCEDURE ------ - -lib: $(OBJ) - mkdir -p build - cd build; cmake -Dlibtype=STATIC -Dlanguage=C -D CMAKE_POSITION_INDEPENDENT_CODE=yes -D CMAKE_C_COMPILER=gcc -D CMAKE_CXX_COMPILER=g++ ../MDI_Library; make - @cp $(EXTRAMAKE) Makefile.lammps - -# ------ CLEAN ------ - -clean: - -rm *.o *.h $(LIB) - -rm -r build diff --git a/lib/mdi/Makefile.gcc b/lib/mdi/Makefile.gcc index 023c0e20df..3653f77a2f 100644 --- a/lib/mdi/Makefile.gcc +++ b/lib/mdi/Makefile.gcc @@ -8,7 +8,7 @@ EXTRAMAKE = Makefile.lammps.empty lib: $(OBJ) mkdir -p build - cd build; cmake -Dlibtype=STATIC -Dlanguage=C -D CMAKE_POSITION_INDEPENDENT_CODE=yes -D CMAKE_C_COMPILER=gcc ../MDI_Library; make + cd build && cmake -D libtype=STATIC -D language=C -D CMAKE_POSITION_INDEPENDENT_CODE=yes -D mpi=ON -D plugins=ON -D python_plugins=ON -D CMAKE_C_COMPILER=gcc ../MDI_Library && make @cp $(EXTRAMAKE) Makefile.lammps # ------ CLEAN ------ diff --git a/lib/mdi/Makefile.icc b/lib/mdi/Makefile.icc index 8c5049561b..615ebf9070 100644 --- a/lib/mdi/Makefile.icc +++ b/lib/mdi/Makefile.icc @@ -8,7 +8,7 @@ EXTRAMAKE = Makefile.lammps.empty lib: $(OBJ) mkdir -p build - cd build; cmake -Dlibtype=STATIC -Dlanguage=C -D CMAKE_POSITION_INDEPENDENT_CODE=yes -D CMAKE_C_COMPILER=icc -D CMAKE_CXX_COMPILER=icpc ../MDI_Library; make + cd build && cmake -D libtype=STATIC -D language=C -D CMAKE_POSITION_INDEPENDENT_CODE=yes -D mpi=ON -D plugins=ON -D python_plugins=ON -D CMAKE_C_COMPILER=icc ../MDI_Library && make @cp $(EXTRAMAKE) Makefile.lammps # ------ CLEAN ------ diff --git a/lib/mdi/Makefile.lammps.empty b/lib/mdi/Makefile.lammps.empty index 3aabe162d2..01c8fe0b70 100644 --- a/lib/mdi/Makefile.lammps.empty +++ b/lib/mdi/Makefile.lammps.empty @@ -1,5 +1,7 @@ # Settings that the LAMMPS build will import when this package library is used -mdi_SYSINC = -mdi_SYSLIB = -mdi_SYSPATH = \ No newline at end of file +mdi_python_SYSLIB = $(shell which python3-config > /dev/null 2>&1 && python3-config --ldflags --embed > /dev/null 2>&1 && python3-config --ldflags --embed || (which python3-config > /dev/null 2>&1 && python3-config --ldflags || :) ) + +mdi_SYSINC = +mdi_SYSLIB = $(mdi_python_SYSLIB) +mdi_SYSPATH = diff --git a/lib/mdi/Makefile.mpi b/lib/mdi/Makefile.mpi index ce40bc9d4d..4274f3e0e8 100644 --- a/lib/mdi/Makefile.mpi +++ b/lib/mdi/Makefile.mpi @@ -8,7 +8,7 @@ EXTRAMAKE = Makefile.lammps.empty lib: $(OBJ) mkdir -p build - cd build; cmake -Dlibtype=STATIC -Dlanguage=C -D CMAKE_POSITION_INDEPENDENT_CODE=yes -D CMAKE_C_COMPILER=mpicc -D CMAKE_CXX_COMPILER=mpicxx ../MDI_Library; make + cd build && cmake -D libtype=STATIC -D language=C -D CMAKE_POSITION_INDEPENDENT_CODE=yes -D mpi=ON -D plugins=ON -D python_plugins=ON -D CMAKE_C_COMPILER=mpicc ../MDI_Library && make @cp $(EXTRAMAKE) Makefile.lammps # ------ CLEAN ------ From ff56f75fca7537d48a1393ea23b0c4e036fd9557 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 30 Jun 2022 15:57:47 -0400 Subject: [PATCH 485/585] abort when there was an error writing to the dump file --- src/dump.cpp | 3 +++ 1 file changed, 3 insertions(+) diff --git a/src/dump.cpp b/src/dump.cpp index a354be4f04..22750ed05c 100644 --- a/src/dump.cpp +++ b/src/dump.cpp @@ -332,6 +332,7 @@ void Dump::write() // if file per timestep, open new file if (multifile) openfile(); + if (fp) clearerr(fp); // simulation box bounds @@ -519,6 +520,8 @@ void Dump::write() if (filewriter && fp != nullptr) write_footer(); + if (fp && ferror(fp)) error->one(FLERR,"Error writing dump {}: {}", id, utils::getsyserror()); + // if file per timestep, close file if I am filewriter if (multifile) { From b6f7dd9df93d47f5fbd8aed82ce84fda8850bb74 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 30 Jun 2022 11:00:36 -0400 Subject: [PATCH 486/585] update googletest to version 1.12.1 --- unittest/CMakeLists.txt | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/unittest/CMakeLists.txt b/unittest/CMakeLists.txt index a015ee6856..28b3e1c1cd 100644 --- a/unittest/CMakeLists.txt +++ b/unittest/CMakeLists.txt @@ -5,8 +5,8 @@ ######################################## # download and build googletest framework message(STATUS "Downloading and building googletest framework") -set(GTEST_URL "https://github.com/google/googletest/archive/8d51dc50eb7e7698427fed81b85edad0e032112e.tar.gz" CACHE STRING "URL of googletest source") -set(GTEST_MD5 "bc33f94adf48a91051dc195077f7e8dc" CACHE STRING "MD5 sum for googletest source") +set(GTEST_URL "https://github.com/google/googletest/archive/release-1.12.1.tar.gz" CACHE STRING "URL of googletest source") +set(GTEST_MD5 "e82199374acdfda3f425331028eb4e2a" CACHE STRING "MD5 sum for googletest source") mark_as_advanced(GTEST_URL) mark_as_advanced(GTEST_MD5) set(gtest_force_shared_crt ON CACHE BOOL "" FORCE) From 454c39ae21db4cdc49e962dd87b44fd6cd2fd5ca Mon Sep 17 00:00:00 2001 From: Jackson Date: Thu, 30 Jun 2022 14:21:11 -0600 Subject: [PATCH 487/585] Invert skipping flag logic. Update keyword and doc to match. --- doc/src/pair_sw.rst | 14 +++--- src/MANYBODY/pair_sw.cpp | 99 ++++++++++++++++++++-------------------- src/MANYBODY/pair_sw.h | 10 ++-- 3 files changed, 62 insertions(+), 61 deletions(-) diff --git a/doc/src/pair_sw.rst b/doc/src/pair_sw.rst index b33371dce8..a83f446a07 100644 --- a/doc/src/pair_sw.rst +++ b/doc/src/pair_sw.rst @@ -24,16 +24,16 @@ Syntax pair_style style keyword values * style = *sw* or *sw/mod* -* keyword = *maxdelcs* or *threebody* +* keyword = *maxdelcs* or *skip_threebody* .. parsed-literal:: *maxdelcs* value = delta1 delta2 (optional) delta1 = The minimum thershold for the variation of cosine of three-body angle delta2 = The maximum threshold for the variation of cosine of three-body angle - *threebody* value = *on* or *off* (optional) - on (default) = Compute both the three-body and two-body terms of the potential - off = Compute only the two-body term of the potential + *skip_threebody* value = *on* or *off* (optional) + off (default) = Compute both the three-body and two-body terms of the potential + on = Compute only the two-body term of the potential Examples @@ -48,7 +48,7 @@ Examples pair_style sw/mod maxdelcs 0.25 0.35 pair_coeff * * tmd.sw.mod Mo S S - pair_style hybrid sw sw threebody off + pair_style hybrid sw sw skip_threebody on pair_coeff * * sw 1 mW_xL.sw mW NULL pair_coeff 1 2 sw 2 mW_xL.sw mW xL pair_coeff 2 2 sw 2 mW_xL.sw mW xL @@ -120,7 +120,7 @@ This value enables the cut-off function to exclude unnecessary angles in the thr However, the angle variation is much smaller than the given threshold value for actual simulations, so the inconsistency between potential and force can be neglected in actual simulations. -The *threebody* keyword determines whether or not the three-body term of the potential is calculated. +The *skip_threebody* keyword determines whether or not the three-body term of the potential is calculated. Skipping this significantly increases the speed of the calculation, with the tradeoff that :math:\lambda_{ijk} is forcibly set to 0. If the keyword is used with the pair styles, sw/gpu, sw/intel, or sw/kokkos, :math:\lambda_{ijk} will still be forcibly set to 0, but no additional benefits will be gained. This keyword @@ -158,7 +158,7 @@ potentials. .. note:: - When the *threebody off* keyword is used, multiple pair_coeff commands may + When the *skip_threebody on* keyword is used, multiple pair_coeff commands may be used to specific the pairs of atoms which don't require three-body term. In these cases, the first 2 arguments are not required to be \* \*. diff --git a/src/MANYBODY/pair_sw.cpp b/src/MANYBODY/pair_sw.cpp index b75c30c04a..3cc402cb5f 100644 --- a/src/MANYBODY/pair_sw.cpp +++ b/src/MANYBODY/pair_sw.cpp @@ -159,51 +159,52 @@ void PairSW::compute(int eflag, int vflag) if (evflag) ev_tally(i,j,nlocal,newton_pair, evdwl,0.0,fpair,delx,dely,delz); } - if (threebody_flag) { - jnumm1 = numshort - 1; - - for (jj = 0; jj < jnumm1; jj++) { - j = neighshort[jj]; - jtype = map[type[j]]; - ijparam = elem3param[itype][jtype][jtype]; - delr1[0] = x[j][0] - xtmp; - delr1[1] = x[j][1] - ytmp; - delr1[2] = x[j][2] - ztmp; - rsq1 = delr1[0]*delr1[0] + delr1[1]*delr1[1] + delr1[2]*delr1[2]; - - double fjxtmp,fjytmp,fjztmp; - fjxtmp = fjytmp = fjztmp = 0.0; - - for (kk = jj+1; kk < numshort; kk++) { - k = neighshort[kk]; - ktype = map[type[k]]; - ikparam = elem3param[itype][ktype][ktype]; - ijkparam = elem3param[itype][jtype][ktype]; - - delr2[0] = x[k][0] - xtmp; - delr2[1] = x[k][1] - ytmp; - delr2[2] = x[k][2] - ztmp; - rsq2 = delr2[0]*delr2[0] + delr2[1]*delr2[1] + delr2[2]*delr2[2]; - - threebody(¶ms[ijparam],¶ms[ikparam],¶ms[ijkparam], - rsq1,rsq2,delr1,delr2,fj,fk,eflag,evdwl); - - fxtmp -= fj[0] + fk[0]; - fytmp -= fj[1] + fk[1]; - fztmp -= fj[2] + fk[2]; - fjxtmp += fj[0]; - fjytmp += fj[1]; - fjztmp += fj[2]; - f[k][0] += fk[0]; - f[k][1] += fk[1]; - f[k][2] += fk[2]; - - if (evflag) ev_tally3(i,j,k,evdwl,0.0,fj,fk,delr1,delr2); - } - f[j][0] += fjxtmp; - f[j][1] += fjytmp; - f[j][2] += fjztmp; + if (skip_threebody_flag) { + jnumm1 = 0; + } else { + jnumm1 = numshort - 1; + } + for (jj = 0; jj < jnumm1; jj++) { + j = neighshort[jj]; + jtype = map[type[j]]; + ijparam = elem3param[itype][jtype][jtype]; + delr1[0] = x[j][0] - xtmp; + delr1[1] = x[j][1] - ytmp; + delr1[2] = x[j][2] - ztmp; + rsq1 = delr1[0]*delr1[0] + delr1[1]*delr1[1] + delr1[2]*delr1[2]; + + double fjxtmp,fjytmp,fjztmp; + fjxtmp = fjytmp = fjztmp = 0.0; + + for (kk = jj+1; kk < numshort; kk++) { + k = neighshort[kk]; + ktype = map[type[k]]; + ikparam = elem3param[itype][ktype][ktype]; + ijkparam = elem3param[itype][jtype][ktype]; + + delr2[0] = x[k][0] - xtmp; + delr2[1] = x[k][1] - ytmp; + delr2[2] = x[k][2] - ztmp; + rsq2 = delr2[0]*delr2[0] + delr2[1]*delr2[1] + delr2[2]*delr2[2]; + + threebody(¶ms[ijparam],¶ms[ikparam],¶ms[ijkparam], + rsq1,rsq2,delr1,delr2,fj,fk,eflag,evdwl); + + fxtmp -= fj[0] + fk[0]; + fytmp -= fj[1] + fk[1]; + fztmp -= fj[2] + fk[2]; + fjxtmp += fj[0]; + fjytmp += fj[1]; + fjztmp += fj[2]; + f[k][0] += fk[0]; + f[k][1] += fk[1]; + f[k][2] += fk[2]; + + if (evflag) ev_tally3(i,j,k,evdwl,0.0,fj,fk,delr1,delr2); } + f[j][0] += fjxtmp; + f[j][1] += fjytmp; + f[j][2] += fjztmp; } f[i][0] += fxtmp; f[i][1] += fytmp; @@ -233,15 +234,15 @@ void PairSW::allocate() void PairSW::settings(int narg, char ** arg) { // Default - threebody_flag = true; + skip_threebody_flag = false; int iarg = 0; while (iarg < narg) { - if (strcmp(arg[iarg],"threebody") == 0) { + if (strcmp(arg[iarg],"skip_threebody") == 0) { if (iarg+2 > narg) error->all(FLERR,"Illegal pair_style command"); - threebody_flag = utils::logical(FLERR,arg[iarg+1],false,lmp); - one_coeff = threebody_flag; + skip_threebody_flag = utils::logical(FLERR,arg[iarg+1],false,lmp); + one_coeff = !skip_threebody_flag; iarg += 2; } else error->all(FLERR,"Illegal pair_style command"); } @@ -368,7 +369,7 @@ void PairSW::read_file(char *file) params[nparams].epsilon *= conversion_factor; } - if (!threebody_flag) params[nparams].lambda = 0; + if (skip_threebody_flag) params[nparams].lambda = 0; if (params[nparams].epsilon < 0.0 || params[nparams].sigma < 0.0 || params[nparams].littlea < 0.0 || params[nparams].lambda < 0.0 || diff --git a/src/MANYBODY/pair_sw.h b/src/MANYBODY/pair_sw.h index 40d3568fb4..aa0aef228e 100644 --- a/src/MANYBODY/pair_sw.h +++ b/src/MANYBODY/pair_sw.h @@ -48,11 +48,11 @@ class PairSW : public Pair { }; protected: - double cutmax; // max cutoff for all elements - Param *params; // parameter set for an I-J-K interaction - int maxshort; // size of short neighbor list array - int *neighshort; // short neighbor list array - int threebody_flag; // whether to run threebody loop + double cutmax; // max cutoff for all elements + Param *params; // parameter set for an I-J-K interaction + int maxshort; // size of short neighbor list array + int *neighshort; // short neighbor list array + int skip_threebody_flag; // whether to run threebody loop void settings(int, char **) override; virtual void allocate(); From 0cd15ab927a2954ab7b0dbf2402dd53353b159ed Mon Sep 17 00:00:00 2001 From: Jackson Date: Thu, 30 Jun 2022 15:24:33 -0600 Subject: [PATCH 488/585] Settings function for sw/angle/table --- src/MANYBODY/pair_sw_angle_table.cpp | 10 ++++++++++ src/MANYBODY/pair_sw_angle_table.h | 1 + 2 files changed, 11 insertions(+) diff --git a/src/MANYBODY/pair_sw_angle_table.cpp b/src/MANYBODY/pair_sw_angle_table.cpp index d66a959d52..6eb7cd8a90 100644 --- a/src/MANYBODY/pair_sw_angle_table.cpp +++ b/src/MANYBODY/pair_sw_angle_table.cpp @@ -751,3 +751,13 @@ void PairSWAngleTable::uf_lookup(ParamTable *pm, double x, double &u, double &f) pm->angtable->deltasq6; } } + + +/* ---------------------------------------------------------------------- + global settings +------------------------------------------------------------------------- */ + +void PairSW::settings(int narg, char **/*arg*/) +{ + if (narg != 0) error->all(FLERR,"Illegal pair_style command"); +} \ No newline at end of file diff --git a/src/MANYBODY/pair_sw_angle_table.h b/src/MANYBODY/pair_sw_angle_table.h index 6257d18283..e8ff8f82cd 100644 --- a/src/MANYBODY/pair_sw_angle_table.h +++ b/src/MANYBODY/pair_sw_angle_table.h @@ -69,6 +69,7 @@ class PairSWAngleTable : public PairSW { void spline(double *, double *, int, double, double, double *); double splint(double *, double *, double *, int, double); void uf_lookup(ParamTable *, double, double &, double &); + void settings(int, char **) override; }; } // namespace LAMMPS_NS From 3d939923b582222e3648ebb6c869a9ccc20337ed Mon Sep 17 00:00:00 2001 From: Jackson Date: Thu, 30 Jun 2022 15:32:08 -0600 Subject: [PATCH 489/585] Fix flag name --- src/OPENMP/pair_sw_omp.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/OPENMP/pair_sw_omp.cpp b/src/OPENMP/pair_sw_omp.cpp index a1c0bec34c..4056c5d0ed 100644 --- a/src/OPENMP/pair_sw_omp.cpp +++ b/src/OPENMP/pair_sw_omp.cpp @@ -156,7 +156,7 @@ void PairSWOMP::eval(int iifrom, int iito, ThrData * const thr) if (EVFLAG) ev_tally_thr(this,i,j,nlocal,/* newton_pair */ 1, evdwl,0.0,fpair,delx,dely,delz,thr); } - if (threebody_flag) { + if (skip_threebody_flag) { jnumm1 = numshort - 1; for (jj = 0; jj < jnumm1; jj++) { From 79468f6d4fe9dac39a94c7d3ed1cc115634d2eb4 Mon Sep 17 00:00:00 2001 From: Jackson Date: Thu, 30 Jun 2022 15:39:02 -0600 Subject: [PATCH 490/585] Fix inverted logic and minimize footprint. --- src/OPENMP/pair_sw_omp.cpp | 73 +++++++++++++++++++------------------- 1 file changed, 37 insertions(+), 36 deletions(-) diff --git a/src/OPENMP/pair_sw_omp.cpp b/src/OPENMP/pair_sw_omp.cpp index 4056c5d0ed..a59922b8c4 100644 --- a/src/OPENMP/pair_sw_omp.cpp +++ b/src/OPENMP/pair_sw_omp.cpp @@ -157,50 +157,51 @@ void PairSWOMP::eval(int iifrom, int iito, ThrData * const thr) evdwl,0.0,fpair,delx,dely,delz,thr); } if (skip_threebody_flag) { + jnumm1 = 0; + } else { jnumm1 = numshort - 1; + } + for (jj = 0; jj < jnumm1; jj++) { + j = neighshort_thr[jj]; + jtype = map[type[j]]; + ijparam = elem3param[itype][jtype][jtype]; + delr1[0] = x[j].x - xtmp; + delr1[1] = x[j].y - ytmp; + delr1[2] = x[j].z - ztmp; + rsq1 = delr1[0]*delr1[0] + delr1[1]*delr1[1] + delr1[2]*delr1[2]; - for (jj = 0; jj < jnumm1; jj++) { - j = neighshort_thr[jj]; - jtype = map[type[j]]; - ijparam = elem3param[itype][jtype][jtype]; - delr1[0] = x[j].x - xtmp; - delr1[1] = x[j].y - ytmp; - delr1[2] = x[j].z - ztmp; - rsq1 = delr1[0]*delr1[0] + delr1[1]*delr1[1] + delr1[2]*delr1[2]; + double fjxtmp,fjytmp,fjztmp; + fjxtmp = fjytmp = fjztmp = 0.0; - double fjxtmp,fjytmp,fjztmp; - fjxtmp = fjytmp = fjztmp = 0.0; + for (kk = jj+1; kk < numshort; kk++) { + k = neighshort_thr[kk]; + ktype = map[type[k]]; + ikparam = elem3param[itype][ktype][ktype]; + ijkparam = elem3param[itype][jtype][ktype]; - for (kk = jj+1; kk < numshort; kk++) { - k = neighshort_thr[kk]; - ktype = map[type[k]]; - ikparam = elem3param[itype][ktype][ktype]; - ijkparam = elem3param[itype][jtype][ktype]; + delr2[0] = x[k].x - xtmp; + delr2[1] = x[k].y - ytmp; + delr2[2] = x[k].z - ztmp; + rsq2 = delr2[0]*delr2[0] + delr2[1]*delr2[1] + delr2[2]*delr2[2]; - delr2[0] = x[k].x - xtmp; - delr2[1] = x[k].y - ytmp; - delr2[2] = x[k].z - ztmp; - rsq2 = delr2[0]*delr2[0] + delr2[1]*delr2[1] + delr2[2]*delr2[2]; + threebody(¶ms[ijparam],¶ms[ikparam],¶ms[ijkparam], + rsq1,rsq2,delr1,delr2,fj,fk,EFLAG,evdwl); - threebody(¶ms[ijparam],¶ms[ikparam],¶ms[ijkparam], - rsq1,rsq2,delr1,delr2,fj,fk,EFLAG,evdwl); + fxtmp -= fj[0] + fk[0]; + fytmp -= fj[1] + fk[1]; + fztmp -= fj[2] + fk[2]; + fjxtmp += fj[0]; + fjytmp += fj[1]; + fjztmp += fj[2]; + f[k].x += fk[0]; + f[k].y += fk[1]; + f[k].z += fk[2]; - fxtmp -= fj[0] + fk[0]; - fytmp -= fj[1] + fk[1]; - fztmp -= fj[2] + fk[2]; - fjxtmp += fj[0]; - fjytmp += fj[1]; - fjztmp += fj[2]; - f[k].x += fk[0]; - f[k].y += fk[1]; - f[k].z += fk[2]; - - if (EVFLAG) ev_tally3_thr(this,i,j,k,evdwl,0.0,fj,fk,delr1,delr2,thr); - } - f[j].x += fjxtmp; - f[j].y += fjytmp; - f[j].z += fjztmp; + if (EVFLAG) ev_tally3_thr(this,i,j,k,evdwl,0.0,fj,fk,delr1,delr2,thr); } + f[j].x += fjxtmp; + f[j].y += fjytmp; + f[j].z += fjztmp; } f[i].x += fxtmp; f[i].y += fytmp; From 36aead3877781a0d6311201137ea12b1bd2ee98d Mon Sep 17 00:00:00 2001 From: Jackson Date: Thu, 30 Jun 2022 16:06:52 -0600 Subject: [PATCH 491/585] Fix class name --- src/MANYBODY/pair_sw_angle_table.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/MANYBODY/pair_sw_angle_table.cpp b/src/MANYBODY/pair_sw_angle_table.cpp index 6eb7cd8a90..7667f77491 100644 --- a/src/MANYBODY/pair_sw_angle_table.cpp +++ b/src/MANYBODY/pair_sw_angle_table.cpp @@ -757,7 +757,7 @@ void PairSWAngleTable::uf_lookup(ParamTable *pm, double x, double &u, double &f) global settings ------------------------------------------------------------------------- */ -void PairSW::settings(int narg, char **/*arg*/) +void PairSWAngleTable::settings(int narg, char **/*arg*/) { if (narg != 0) error->all(FLERR,"Illegal pair_style command"); } \ No newline at end of file From 4ff683a3ca73046882a5e0d6a18c6ce8c26131ac Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 30 Jun 2022 23:53:57 -0400 Subject: [PATCH 492/585] MPI may need to include multiple folders (e.g. on Ubuntu with OpenMPI) --- cmake/Modules/Packages/ML-HDNNP.cmake | 4 +++- 1 file changed, 3 insertions(+), 1 deletion(-) diff --git a/cmake/Modules/Packages/ML-HDNNP.cmake b/cmake/Modules/Packages/ML-HDNNP.cmake index f52d7ca6f3..71f024aedd 100644 --- a/cmake/Modules/Packages/ML-HDNNP.cmake +++ b/cmake/Modules/Packages/ML-HDNNP.cmake @@ -44,7 +44,9 @@ if(DOWNLOAD_N2P2) else() # get path to MPI include directory get_target_property(N2P2_MPI_INCLUDE MPI::MPI_CXX INTERFACE_INCLUDE_DIRECTORIES) - set(N2P2_PROJECT_OPTIONS "-I${N2P2_MPI_INCLUDE}") + foreach (_INCL ${N2P2_MPI_INCLUDE}) + set(N2P2_PROJECT_OPTIONS "${N2P2_PROJECT_OPTIONS} -I${_INCL}") + endforeach() endif() # prefer GNU make, if available. N2P2 lib seems to need it. From 940cbe31330455e18f3ac8ec7f273acc7645fade Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Thu, 30 Jun 2022 11:27:56 -0600 Subject: [PATCH 493/585] Updated timestamp for local array --- src/ML-SNAP/compute_sna_grid_local.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/ML-SNAP/compute_sna_grid_local.cpp b/src/ML-SNAP/compute_sna_grid_local.cpp index 80a1baddab..76fe03a03b 100644 --- a/src/ML-SNAP/compute_sna_grid_local.cpp +++ b/src/ML-SNAP/compute_sna_grid_local.cpp @@ -203,7 +203,7 @@ void ComputeSNAGridLocal::init() void ComputeSNAGridLocal::compute_local() { - invoked_array = update->ntimestep; + invoked_local = update->ntimestep; // compute sna for each gridpoint From 41bb5850b3cce4bb821ff14e649eb904ca16ea11 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Thu, 30 Jun 2022 17:27:17 -0600 Subject: [PATCH 494/585] Fixed temperature in argon GK example --- doc/src/Howto_viscosity.rst | 16 ++++++++++------ 1 file changed, 10 insertions(+), 6 deletions(-) diff --git a/doc/src/Howto_viscosity.rst b/doc/src/Howto_viscosity.rst index 5cabf63de3..94be9589e0 100644 --- a/doc/src/Howto_viscosity.rst +++ b/doc/src/Howto_viscosity.rst @@ -65,10 +65,11 @@ liquid Ar via the GK formalism: .. code-block:: LAMMPS - # Sample LAMMPS input script for viscosity of liquid Ar +# Sample LAMMPS input script for viscosity of liquid Ar units real - variable T equal 86.4956 + variable T equal 200.0 # run temperature + variable Tinit equal 250.0 # equilibration temperature variable V equal vol variable dt equal 4.0 variable p equal 400 # correlation length @@ -99,12 +100,14 @@ liquid Ar via the GK formalism: # equilibration and thermalization - velocity all create $T 102486 mom yes rot yes dist gaussian - fix NVT all nvt temp $T $T 10 drag 0.2 + velocity all create ${Tinit} 102486 mom yes rot yes dist gaussian + fix NVT all nvt temp ${Tinit} ${Tinit} 10 drag 0.2 run 8000 # viscosity calculation, switch to NVE if desired + velocity all create $T 102486 mom yes rot yes dist gaussian + #fix NVT all nvt temp $T $T 10 drag 0.2 #unfix NVT #fix NVE all nve @@ -113,12 +116,13 @@ liquid Ar via the GK formalism: variable pxz equal pxz variable pyz equal pyz fix SS all ave/correlate $s $p $d & - v_pxy v_pxz v_pyz type auto file S0St.dat ave running + v_pxy v_pxz v_pyz type auto file S0St.dat ave running variable scale equal ${convert}/(${kB}*$T)*$V*$s*${dt} variable v11 equal trap(f_SS[3])*${scale} variable v22 equal trap(f_SS[4])*${scale} variable v33 equal trap(f_SS[5])*${scale} - thermo_style custom step temp press v_pxy v_pxz v_pyz v_v11 v_v22 v_v33 + compute msd all msd com yes + thermo_style custom step temp press v_pxy v_pxz v_pyz v_v11 v_v22 v_v33 c_msd[*] run 100000 variable v equal (v_v11+v_v22+v_v33)/3.0 variable ndens equal count(all)/vol From 6a813bba692b323786e75b4c9a00be140f31a68e Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 1 Jul 2022 04:36:49 -0400 Subject: [PATCH 495/585] restore bikflag parsing and initialization that was removed in commit 44436c0eb662fb4e396c8496354bbe59b04e3f31 --- src/ML-SNAP/compute_snap.cpp | 11 +++++++---- 1 file changed, 7 insertions(+), 4 deletions(-) diff --git a/src/ML-SNAP/compute_snap.cpp b/src/ML-SNAP/compute_snap.cpp index d1f75f8382..12a5167b2d 100644 --- a/src/ML-SNAP/compute_snap.cpp +++ b/src/ML-SNAP/compute_snap.cpp @@ -57,6 +57,7 @@ ComputeSnap::ComputeSnap(LAMMPS *lmp, int narg, char **arg) : switchflag = 1; bzeroflag = 1; quadraticflag = 0; + bikflag = 0; chemflag = 0; bnormflag = 0; wselfallflag = 0; @@ -73,11 +74,9 @@ ComputeSnap::ComputeSnap(LAMMPS *lmp, int narg, char **arg) : twojmax = utils::inumeric(FLERR, arg[5], false, lmp); for (int i = 0; i < ntypes; i++) - radelem[i + 1] = - utils::numeric(FLERR, arg[6 + i], false, lmp); + radelem[i + 1] = utils::numeric(FLERR, arg[6 + i], false, lmp); for (int i = 0; i < ntypes; i++) - wjelem[i + 1] = - utils::numeric(FLERR, arg[6 + ntypes + i], false, lmp); + wjelem[i + 1] = utils::numeric(FLERR, arg[6 + ntypes + i], false, lmp); // construct cutsq @@ -139,6 +138,10 @@ ComputeSnap::ComputeSnap(LAMMPS *lmp, int narg, char **arg) : if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); wselfallflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; + } else if (strcmp(arg[iarg], "bikflag") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); + bikflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); + iarg += 2; } else if (strcmp(arg[iarg], "switchinnerflag") == 0) { if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); switchinnerflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); From 0157a7d0d37f88b55afd94ef8aee3bfc87714e6b Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 1 Jul 2022 05:49:07 -0400 Subject: [PATCH 496/585] make certain to switch to the expected source folder when building n2p2 lib --- cmake/Modules/Packages/ML-HDNNP.cmake | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/cmake/Modules/Packages/ML-HDNNP.cmake b/cmake/Modules/Packages/ML-HDNNP.cmake index 71f024aedd..f71d08f3ab 100644 --- a/cmake/Modules/Packages/ML-HDNNP.cmake +++ b/cmake/Modules/Packages/ML-HDNNP.cmake @@ -77,7 +77,7 @@ if(DOWNLOAD_N2P2) UPDATE_COMMAND "" CONFIGURE_COMMAND "" PATCH_COMMAND sed -i -e "s/\\(MPI_\\(P\\|Unp\\)ack(\\)/\\1(void *) /" src/libnnpif/LAMMPS/InterfaceLammps.cpp - BUILD_COMMAND ${N2P2_MAKE} -f makefile libnnpif ${N2P2_BUILD_OPTIONS} + BUILD_COMMAND ${N2P2_MAKE} -C /src -f makefile libnnpif ${N2P2_BUILD_OPTIONS} BUILD_ALWAYS YES INSTALL_COMMAND "" BUILD_IN_SOURCE 1 From 957a8c85a91e2880809d79fb9c60eb039798d7c9 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 1 Jul 2022 09:26:23 -0400 Subject: [PATCH 497/585] formatting corrections and minor tweaks to the Argon viscosity howto --- doc/src/Howto_viscosity.rst | 17 ++++++++--------- 1 file changed, 8 insertions(+), 9 deletions(-) diff --git a/doc/src/Howto_viscosity.rst b/doc/src/Howto_viscosity.rst index 94be9589e0..3c97628179 100644 --- a/doc/src/Howto_viscosity.rst +++ b/doc/src/Howto_viscosity.rst @@ -65,7 +65,7 @@ liquid Ar via the GK formalism: .. code-block:: LAMMPS -# Sample LAMMPS input script for viscosity of liquid Ar + # Sample LAMMPS input script for viscosity of liquid Ar units real variable T equal 200.0 # run temperature @@ -107,7 +107,7 @@ liquid Ar via the GK formalism: # viscosity calculation, switch to NVE if desired velocity all create $T 102486 mom yes rot yes dist gaussian - #fix NVT all nvt temp $T $T 10 drag 0.2 + fix NVT all nvt temp $T $T 10 drag 0.2 #unfix NVT #fix NVE all nve @@ -116,17 +116,16 @@ liquid Ar via the GK formalism: variable pxz equal pxz variable pyz equal pyz fix SS all ave/correlate $s $p $d & - v_pxy v_pxz v_pyz type auto file S0St.dat ave running + v_pxy v_pxz v_pyz type auto file S0St.dat ave running variable scale equal ${convert}/(${kB}*$T)*$V*$s*${dt} variable v11 equal trap(f_SS[3])*${scale} variable v22 equal trap(f_SS[4])*${scale} variable v33 equal trap(f_SS[5])*${scale} - compute msd all msd com yes - thermo_style custom step temp press v_pxy v_pxz v_pyz v_v11 v_v22 v_v33 c_msd[*] + thermo_style custom step temp press v_pxy v_pxz v_pyz v_v11 v_v22 v_v33 run 100000 variable v equal (v_v11+v_v22+v_v33)/3.0 variable ndens equal count(all)/vol - print "average viscosity: $v [Pa.s] @ $T K, ${ndens} /A^3" + print "average viscosity: $v [Pa.s] @ $T K, ${ndens} atoms/A^3" The fifth method is related to the above Green-Kubo method, but uses the Einstein formulation, analogous to the Einstein @@ -135,9 +134,9 @@ time-integrated momentum fluxes play the role of Cartesian coordinates, whose mean-square displacement increases linearly with time at sufficiently long times. -The sixth is periodic perturbation method. It is also a non-equilibrium MD method. -However, instead of measure the momentum flux in response of applied velocity gradient, -it measures the velocity profile in response of applied stress. +The sixth is the periodic perturbation method, which is also a non-equilibrium MD method. +However, instead of measuring the momentum flux in response to an applied velocity gradient, +it measures the velocity profile in response to applied stress. A cosine-shaped periodic acceleration is added to the system via the :doc:`fix accelerate/cos ` command, and the :doc:`compute viscosity/cos` command is used to monitor the From ae7215037d5e4601bb8d2563548290cab8acb131 Mon Sep 17 00:00:00 2001 From: Stan Moore Date: Fri, 1 Jul 2022 11:20:51 -0600 Subject: [PATCH 498/585] Finish porting pair MEAM to Kokkos --- doc/src/Commands_pair.rst | 2 +- doc/src/package.rst | 18 +- doc/src/pair_meam.rst | 9 + src/KOKKOS/Install.sh | 16 +- src/KOKKOS/comm_kokkos.cpp | 82 +++- src/KOKKOS/comm_kokkos.h | 2 + src/KOKKOS/kokkos.cpp | 27 +- src/KOKKOS/kokkos.h | 2 + src/KOKKOS/kokkos_base.h | 4 + src/KOKKOS/math_special_kokkos.cpp | 251 ++++++++--- src/KOKKOS/math_special_kokkos.h | 221 ++++++++-- src/KOKKOS/meam_dens_final_kokkos.h | 267 +++++------- src/KOKKOS/meam_dens_init_kokkos.h | 646 +++++++++++++++------------- src/KOKKOS/meam_force_kokkos.h | 374 ++++++++-------- src/KOKKOS/meam_funcs_kokkos.h | 182 ++++---- src/KOKKOS/meam_impl_kokkos.h | 17 +- src/KOKKOS/meam_kokkos.h | 136 +++--- src/KOKKOS/meam_setup_done_kokkos.h | 97 ++--- src/KOKKOS/pair_meam_kokkos.cpp | 625 ++++++++++++++++----------- src/KOKKOS/pair_meam_kokkos.h | 133 ++---- src/MEAM/meam.h | 8 +- src/MEAM/meam_impl.cpp | 3 + src/MEAM/pair_meam.cpp | 3 +- src/MEAM/pair_meam.h | 2 +- src/pair.cpp | 1 + src/pair.h | 1 + 26 files changed, 1806 insertions(+), 1323 deletions(-) diff --git a/doc/src/Commands_pair.rst b/doc/src/Commands_pair.rst index f902b40b29..11334ea2d1 100644 --- a/doc/src/Commands_pair.rst +++ b/doc/src/Commands_pair.rst @@ -194,7 +194,7 @@ OPT. * :doc:`lubricateU/poly ` * :doc:`mdpd ` * :doc:`mdpd/rhosum ` - * :doc:`meam ` + * :doc:`meam (k) ` * :doc:`meam/spline (o) ` * :doc:`meam/sw/spline ` * :doc:`mesocnt ` diff --git a/doc/src/package.rst b/doc/src/package.rst index 8f9a65b2cc..6ff34515cf 100644 --- a/doc/src/package.rst +++ b/doc/src/package.rst @@ -71,7 +71,7 @@ Syntax *no_affinity* values = none *kokkos* args = keyword value ... zero or more keyword/value pairs may be appended - keywords = *neigh* or *neigh/qeq* or *neigh/thread* or *newton* or *binsize* or *comm* or *comm/exchange* or *comm/forward* *comm/pair/forward* *comm/fix/forward* or *comm/reverse* or *gpu/aware* or *pair/only* + keywords = *neigh* or *neigh/qeq* or *neigh/thread* or *newton* or *binsize* or *comm* or *comm/exchange* or *comm/forward* *comm/pair/forward* *comm/fix/forward* or *comm/reverse* or *comm/pair/reverse* or *gpu/aware* or *pair/only* *neigh* value = *full* or *half* full = full neighbor list half = half neighbor list built in thread-safe manner @@ -96,6 +96,7 @@ Syntax *comm/pair/forward* value = *no* or *device* *comm/fix/forward* value = *no* or *device* *comm/reverse* value = *no* or *host* or *device* + *comm/pair/reverse* value = *no* or *device* no = perform communication pack/unpack in non-KOKKOS mode host = perform pack/unpack on host (e.g. with OpenMP threading) device = perform pack/unpack on device (e.g. on GPU) @@ -500,7 +501,7 @@ rule of thumb may give too large a binsize and the default should be overridden with a smaller value. The *comm* and *comm/exchange* and *comm/forward* and *comm/pair/forward* -and *comm/fix/forward* and comm/reverse* +and *comm/fix/forward* and *comm/reverse* and *comm/pair/reverse* keywords determine whether the host or device performs the packing and unpacking of data when communicating per-atom data between processors. "Exchange" communication happens only on timesteps that neighbor lists @@ -521,9 +522,16 @@ packing/unpacking data for the communication. A value of *host* means to use the host, typically a multi-core CPU, and perform the packing/unpacking in parallel with threads. A value of *device* means to use the device, typically a GPU, to perform the packing/unpacking -operation. If a value of *host* is used for the *comm/pair/forward* or -*comm/fix/forward* keyword, it will be automatically be changed to *no* -since these keywords don't support *host* mode. +operation. + +For the *comm/pair/forward* or *comm/fix/forward* or *comm/pair/reverse* +keywords, if a value of *host* is used it will be automatically +be changed to *no* since these keywords don't support *host* mode. The +value of *no* will also always be used when running on the CPU, i.e. setting +the value to *device* will have no effect if the pair/fix style is +running on the CPU. For the *comm/fix/forward* or *comm/pair/reverse* +keywords, not all styles support *device* mode and in that case will run +in *no* mode instead. The optimal choice for these keywords depends on the input script and the hardware used. The *no* value is useful for verifying that the diff --git a/doc/src/pair_meam.rst b/doc/src/pair_meam.rst index afa89e10ca..eac8449b21 100644 --- a/doc/src/pair_meam.rst +++ b/doc/src/pair_meam.rst @@ -1,8 +1,11 @@ .. index:: pair_style meam +.. index:: pair_style meam/kk pair_style meam command ========================= +Accelerator Variants: *meam/kk* + Syntax """""" @@ -347,6 +350,12 @@ Most published MEAM parameter sets use the default values *attrac* = *repulse* = Setting *repuls* = *attrac* = *delta* corresponds to the form used in several recent published MEAM parameter sets, such as :ref:`(Valone) ` +---------- + +.. include:: accel_styles.rst + +---------- + .. note:: The default form of the *erose* expression in LAMMPS was corrected diff --git a/src/KOKKOS/Install.sh b/src/KOKKOS/Install.sh index 952f21e403..314205ea3e 100755 --- a/src/KOKKOS/Install.sh +++ b/src/KOKKOS/Install.sh @@ -182,6 +182,13 @@ action kokkos_base.h action kokkos_base_fft.h fft3d.h action kokkos_few.h action kokkos_type.h +action meam_kokkos.h meam.h +action meam_dens_final_kokkos.h meam_dens_final.cpp +action meam_dens_init_kokkos.h meam_dens_init.cpp +action meam_force_kokkos.h meam_force.cpp +action meam_funcs_kokkos.h meam_funcs.cpp +action meam_impl_kokkos.h meam_impl.cpp +action meam_setup_done_kokkos.h meam_setup_done.cpp action memory_kokkos.h action modify_kokkos.cpp action modify_kokkos.h @@ -207,13 +214,6 @@ action nbin_ssa_kokkos.cpp nbin_ssa.cpp action nbin_ssa_kokkos.h nbin_ssa.h action math_special_kokkos.cpp action math_special_kokkos.h -action meam_setup_done_kokkos.h meam_setup_done.cpp -action meam_kokkos.h meam.h -action meam_impl_kokkos.h meam_impl.cpp -action meam_funcs_kokkos.h meam_funcs.cpp -action meam_force_kokkos.h meam_force.cpp -action meam_dens_init_kokkos.h meam_dens_init.cpp -action meam_dens_final_kokkos.h meam_dens_final.cpp action min_cg_kokkos.cpp action min_cg_kokkos.h action min_kokkos.cpp @@ -294,8 +294,8 @@ action pair_lj_gromacs_kokkos.cpp pair_lj_gromacs.cpp action pair_lj_gromacs_kokkos.h pair_lj_gromacs.h action pair_lj_sdk_kokkos.cpp pair_lj_sdk.cpp action pair_lj_sdk_kokkos.h pair_lj_sdk.h -action pair_meam_kokkos.h pair_meam.h action pair_meam_kokkos.cpp pair_meam.cpp +action pair_meam_kokkos.h pair_meam.h action pair_morse_kokkos.cpp action pair_morse_kokkos.h action pair_multi_lucy_rx_kokkos.cpp pair_multi_lucy_rx.cpp diff --git a/src/KOKKOS/comm_kokkos.cpp b/src/KOKKOS/comm_kokkos.cpp index 4883838273..fea5864225 100644 --- a/src/KOKKOS/comm_kokkos.cpp +++ b/src/KOKKOS/comm_kokkos.cpp @@ -109,6 +109,7 @@ void CommKokkos::init() exchange_comm_classic = lmp->kokkos->exchange_comm_classic; forward_comm_classic = lmp->kokkos->forward_comm_classic; forward_pair_comm_classic = lmp->kokkos->forward_pair_comm_classic; + reverse_pair_comm_classic = lmp->kokkos->reverse_pair_comm_classic; forward_fix_comm_classic = lmp->kokkos->forward_fix_comm_classic; reverse_comm_classic = lmp->kokkos->reverse_comm_classic; exchange_comm_on_host = lmp->kokkos->exchange_comm_on_host; @@ -478,12 +479,13 @@ void CommKokkos::forward_comm_device(Pair *pair) int nsize = pair->comm_forward; KokkosBase* pairKKBase = dynamic_cast(pair); + int nmax = max_buf_pair; for (iswap = 0; iswap < nswap; iswap++) { - int n = MAX(max_buf_pair,nsize*sendnum[iswap]); - n = MAX(n,nsize*recvnum[iswap]); - if (n > max_buf_pair) - grow_buf_pair(n); + nmax = MAX(nmax,nsize*sendnum[iswap]); + nmax = MAX(nmax,nsize*recvnum[iswap]); } + if (nmax > max_buf_pair) + grow_buf_pair(nmax); for (iswap = 0; iswap < nswap; iswap++) { @@ -545,8 +547,76 @@ void CommKokkos::grow_buf_fix(int n) { void CommKokkos::reverse_comm(Pair *pair) { - k_sendlist.sync(); - CommBrick::reverse_comm(pair); + if (pair->execution_space == Host || !pair->reverse_comm_device || reverse_pair_comm_classic) { + k_sendlist.sync(); + CommBrick::reverse_comm(pair); + } else { + k_sendlist.sync(); + reverse_comm_device(pair); + } +} + +template +void CommKokkos::reverse_comm_device(Pair *pair) +{ + int iswap,n; + MPI_Request request; + DAT::tdual_xfloat_1d k_buf_tmp; + + KokkosBase* pairKKBase = dynamic_cast(pair); + + int nsize = MAX(pair->comm_reverse,pair->comm_reverse_off); + + int nmax = max_buf_pair; + for (iswap = 0; iswap < nswap; iswap++) { + nmax = MAX(nmax,nsize*sendnum[iswap]); + nmax = MAX(nmax,nsize*recvnum[iswap]); + } + if (nmax > max_buf_pair) + grow_buf_pair(nmax); + + for (iswap = nswap-1; iswap >= 0; iswap--) { + + // pack buffer + + n = pairKKBase->pack_reverse_comm_kokkos(recvnum[iswap],firstrecv[iswap],k_buf_send_pair); + DeviceType().fence(); + + // exchange with another proc + // if self, set recv buffer to send buffer + + double* buf_send_pair; + double* buf_recv_pair; + if (lmp->kokkos->gpu_aware_flag) { + buf_send_pair = k_buf_send_pair.view().data(); + buf_recv_pair = k_buf_recv_pair.view().data(); + } else { + k_buf_send_pair.modify(); + k_buf_send_pair.sync(); + buf_send_pair = k_buf_send_pair.h_view.data(); + buf_recv_pair = k_buf_recv_pair.h_view.data(); + } + + if (sendproc[iswap] != me) { + if (sendnum[iswap]) + MPI_Irecv(buf_recv_pair,nsize*sendnum[iswap],MPI_DOUBLE,sendproc[iswap],0,world,&request); + if (recvnum[iswap]) + MPI_Send(buf_send_pair,n,MPI_DOUBLE,recvproc[iswap],0,world); + if (sendnum[iswap]) MPI_Wait(&request,MPI_STATUS_IGNORE); + + if (!lmp->kokkos->gpu_aware_flag) { + k_buf_recv_pair.modify(); + k_buf_recv_pair.sync(); + } + k_buf_tmp = k_buf_recv_pair; + } else k_buf_tmp = k_buf_send_pair; + + // unpack buffer + + pairKKBase->unpack_reverse_comm_kokkos(sendnum[iswap],k_sendlist, + iswap,k_buf_tmp); + DeviceType().fence(); + } } void CommKokkos::forward_comm(Dump *dump) diff --git a/src/KOKKOS/comm_kokkos.h b/src/KOKKOS/comm_kokkos.h index 3fcce82e2c..80736c1f92 100644 --- a/src/KOKKOS/comm_kokkos.h +++ b/src/KOKKOS/comm_kokkos.h @@ -27,6 +27,7 @@ class CommKokkos : public CommBrick { bool exchange_comm_classic; bool forward_comm_classic; bool forward_pair_comm_classic; + bool reverse_pair_comm_classic; bool forward_fix_comm_classic; bool reverse_comm_classic; bool exchange_comm_on_host; @@ -58,6 +59,7 @@ class CommKokkos : public CommBrick { template void forward_comm_device(int dummy); template void reverse_comm_device(); template void forward_comm_device(Pair *pair); + template void reverse_comm_device(Pair *pair); template void forward_comm_device(Fix *fix, int size=0); template void exchange_device(); template void borders_device(); diff --git a/src/KOKKOS/kokkos.cpp b/src/KOKKOS/kokkos.cpp index 18f05fa281..3ecce0d75d 100644 --- a/src/KOKKOS/kokkos.cpp +++ b/src/KOKKOS/kokkos.cpp @@ -91,6 +91,7 @@ KokkosLMP::KokkosLMP(LAMMPS *lmp, int narg, char **arg) : Pointers(lmp) exchange_comm_changed = 0; forward_comm_changed = 0; forward_pair_comm_changed = 0; + reverse_pair_comm_changed = 0; forward_fix_comm_changed = 0; reverse_comm_changed = 0; @@ -239,7 +240,7 @@ KokkosLMP::KokkosLMP(LAMMPS *lmp, int narg, char **arg) : Pointers(lmp) newtonflag = 0; exchange_comm_classic = forward_comm_classic = reverse_comm_classic = 0; - forward_pair_comm_classic = forward_fix_comm_classic = 0; + forward_pair_comm_classic = reverse_pair_comm_classic = forward_fix_comm_classic = 0; exchange_comm_on_host = forward_comm_on_host = reverse_comm_on_host = 0; } else { @@ -253,7 +254,7 @@ KokkosLMP::KokkosLMP(LAMMPS *lmp, int narg, char **arg) : Pointers(lmp) newtonflag = 1; exchange_comm_classic = forward_comm_classic = reverse_comm_classic = 1; - forward_pair_comm_classic = forward_fix_comm_classic = 1; + forward_pair_comm_classic = reverse_pair_comm_classic = forward_fix_comm_classic = 1; exchange_comm_on_host = forward_comm_on_host = reverse_comm_on_host = 0; } @@ -394,17 +395,17 @@ void KokkosLMP::accelerator(int narg, char **arg) if (iarg+2 > narg) error->all(FLERR,"Illegal package kokkos command"); if (strcmp(arg[iarg+1],"no") == 0) { exchange_comm_classic = forward_comm_classic = reverse_comm_classic = 1; - forward_pair_comm_classic = forward_fix_comm_classic = 1; + forward_pair_comm_classic = reverse_pair_comm_classic = forward_fix_comm_classic = 1; exchange_comm_on_host = forward_comm_on_host = reverse_comm_on_host = 0; } else if (strcmp(arg[iarg+1],"host") == 0) { exchange_comm_classic = forward_comm_classic = reverse_comm_classic = 0; - forward_pair_comm_classic = forward_fix_comm_classic = 1; + forward_pair_comm_classic = reverse_pair_comm_classic = forward_fix_comm_classic = 1; exchange_comm_on_host = forward_comm_on_host = reverse_comm_on_host = 1; } else if (strcmp(arg[iarg+1],"device") == 0) { exchange_comm_classic = forward_comm_classic = reverse_comm_classic = 0; - forward_pair_comm_classic = forward_fix_comm_classic = 0; + forward_pair_comm_classic = reverse_pair_comm_classic = forward_fix_comm_classic = 0; exchange_comm_on_host = forward_comm_on_host = reverse_comm_on_host = 0; } else error->all(FLERR,"Illegal package kokkos command"); @@ -441,6 +442,14 @@ void KokkosLMP::accelerator(int narg, char **arg) else error->all(FLERR,"Illegal package kokkos command"); forward_pair_comm_changed = 0; iarg += 2; + } else if (strcmp(arg[iarg],"comm/pair/reverse") == 0) { + if (iarg+2 > narg) error->all(FLERR,"Illegal package kokkos command"); + if (strcmp(arg[iarg+1],"no") == 0) reverse_pair_comm_classic = 1; + else if (strcmp(arg[iarg+1],"host") == 0) reverse_pair_comm_classic = 1; + else if (strcmp(arg[iarg+1],"device") == 0) reverse_pair_comm_classic = 0; + else error->all(FLERR,"Illegal package kokkos command"); + reverse_pair_comm_changed = 0; + iarg += 2; } else if (strcmp(arg[iarg],"comm/fix/forward") == 0) { if (iarg+2 > narg) error->all(FLERR,"Illegal package kokkos command"); if (strcmp(arg[iarg+1],"no") == 0) forward_fix_comm_classic = 1; @@ -515,6 +524,10 @@ void KokkosLMP::accelerator(int narg, char **arg) forward_pair_comm_classic = 1; forward_pair_comm_changed = 1; } + if (reverse_pair_comm_classic == 0) { + reverse_pair_comm_classic = 1; + reverse_pair_comm_changed = 1; + } if (forward_fix_comm_classic == 0) { forward_fix_comm_classic = 1; forward_fix_comm_changed = 1; @@ -540,6 +553,10 @@ void KokkosLMP::accelerator(int narg, char **arg) forward_pair_comm_classic = 0; forward_pair_comm_changed = 0; } + if (reverse_pair_comm_changed) { + reverse_pair_comm_classic = 0; + reverse_pair_comm_changed = 0; + } if (forward_fix_comm_changed) { forward_fix_comm_classic = 0; forward_fix_comm_changed = 0; diff --git a/src/KOKKOS/kokkos.h b/src/KOKKOS/kokkos.h index 07d172e524..1cecd69c5f 100644 --- a/src/KOKKOS/kokkos.h +++ b/src/KOKKOS/kokkos.h @@ -30,6 +30,7 @@ class KokkosLMP : protected Pointers { int exchange_comm_classic; int forward_comm_classic; int forward_pair_comm_classic; + int reverse_pair_comm_classic; int forward_fix_comm_classic; int reverse_comm_classic; int exchange_comm_on_host; @@ -38,6 +39,7 @@ class KokkosLMP : protected Pointers { int exchange_comm_changed; int forward_comm_changed; int forward_pair_comm_changed; + int reverse_pair_comm_changed; int forward_fix_comm_changed; int reverse_comm_changed; int nthreads,ngpus; diff --git a/src/KOKKOS/kokkos_base.h b/src/KOKKOS/kokkos_base.h index f18d55eec2..c593f0ae60 100644 --- a/src/KOKKOS/kokkos_base.h +++ b/src/KOKKOS/kokkos_base.h @@ -29,6 +29,10 @@ class KokkosBase { int, int *) {return 0;}; virtual void unpack_forward_comm_kokkos(int, int, DAT::tdual_xfloat_1d &) {} + virtual int pack_reverse_comm_kokkos(int, int, DAT::tdual_xfloat_1d &) {return 0;}; + virtual void unpack_reverse_comm_kokkos(int, DAT::tdual_int_2d, + int, DAT::tdual_xfloat_1d &) {} + // Fix virtual int pack_forward_comm_fix_kokkos(int, DAT::tdual_int_2d, int, DAT::tdual_xfloat_1d &, diff --git a/src/KOKKOS/math_special_kokkos.cpp b/src/KOKKOS/math_special_kokkos.cpp index 89f6586581..eca64fbb4e 100644 --- a/src/KOKKOS/math_special_kokkos.cpp +++ b/src/KOKKOS/math_special_kokkos.cpp @@ -1,11 +1,202 @@ // clang-format off - #include "math_special_kokkos.h" + #include -#include +#include // IWYU pragma: keep +#include using namespace LAMMPS_NS; +static constexpr int nmaxfactorial = 167; + +/* ---------------------------------------------------------------------- + factorial n table, size nmaxfactorial+1 +------------------------------------------------------------------------- */ + +static const double nfac_table[] = { + 1, + 1, + 2, + 6, + 24, + 120, + 720, + 5040, + 40320, + 362880, + 3628800, + 39916800, + 479001600, + 6227020800, + 87178291200, + 1307674368000, + 20922789888000, + 355687428096000, + 6.402373705728e+15, + 1.21645100408832e+17, + 2.43290200817664e+18, + 5.10909421717094e+19, + 1.12400072777761e+21, + 2.5852016738885e+22, + 6.20448401733239e+23, + 1.5511210043331e+25, + 4.03291461126606e+26, + 1.08888694504184e+28, + 3.04888344611714e+29, + 8.8417619937397e+30, + 2.65252859812191e+32, + 8.22283865417792e+33, + 2.63130836933694e+35, + 8.68331761881189e+36, + 2.95232799039604e+38, + 1.03331479663861e+40, + 3.71993326789901e+41, + 1.37637530912263e+43, + 5.23022617466601e+44, + 2.03978820811974e+46, + 8.15915283247898e+47, + 3.34525266131638e+49, + 1.40500611775288e+51, + 6.04152630633738e+52, + 2.65827157478845e+54, + 1.1962222086548e+56, + 5.50262215981209e+57, + 2.58623241511168e+59, + 1.24139155925361e+61, + 6.08281864034268e+62, + 3.04140932017134e+64, + 1.55111875328738e+66, + 8.06581751709439e+67, + 4.27488328406003e+69, + 2.30843697339241e+71, + 1.26964033536583e+73, + 7.10998587804863e+74, + 4.05269195048772e+76, + 2.35056133128288e+78, + 1.3868311854569e+80, + 8.32098711274139e+81, + 5.07580213877225e+83, + 3.14699732603879e+85, + 1.98260831540444e+87, + 1.26886932185884e+89, + 8.24765059208247e+90, + 5.44344939077443e+92, + 3.64711109181887e+94, + 2.48003554243683e+96, + 1.71122452428141e+98, + 1.19785716699699e+100, + 8.50478588567862e+101, + 6.12344583768861e+103, + 4.47011546151268e+105, + 3.30788544151939e+107, + 2.48091408113954e+109, + 1.88549470166605e+111, + 1.45183092028286e+113, + 1.13242811782063e+115, + 8.94618213078297e+116, + 7.15694570462638e+118, + 5.79712602074737e+120, + 4.75364333701284e+122, + 3.94552396972066e+124, + 3.31424013456535e+126, + 2.81710411438055e+128, + 2.42270953836727e+130, + 2.10775729837953e+132, + 1.85482642257398e+134, + 1.65079551609085e+136, + 1.48571596448176e+138, + 1.3520015276784e+140, + 1.24384140546413e+142, + 1.15677250708164e+144, + 1.08736615665674e+146, + 1.03299784882391e+148, + 9.91677934870949e+149, + 9.61927596824821e+151, + 9.42689044888324e+153, + 9.33262154439441e+155, + 9.33262154439441e+157, + 9.42594775983835e+159, + 9.61446671503512e+161, + 9.90290071648618e+163, + 1.02990167451456e+166, + 1.08139675824029e+168, + 1.14628056373471e+170, + 1.22652020319614e+172, + 1.32464181945183e+174, + 1.44385958320249e+176, + 1.58824554152274e+178, + 1.76295255109024e+180, + 1.97450685722107e+182, + 2.23119274865981e+184, + 2.54355973347219e+186, + 2.92509369349301e+188, + 3.3931086844519e+190, + 3.96993716080872e+192, + 4.68452584975429e+194, + 5.5745857612076e+196, + 6.68950291344912e+198, + 8.09429852527344e+200, + 9.8750442008336e+202, + 1.21463043670253e+205, + 1.50614174151114e+207, + 1.88267717688893e+209, + 2.37217324288005e+211, + 3.01266001845766e+213, + 3.8562048236258e+215, + 4.97450422247729e+217, + 6.46685548922047e+219, + 8.47158069087882e+221, + 1.118248651196e+224, + 1.48727070609069e+226, + 1.99294274616152e+228, + 2.69047270731805e+230, + 3.65904288195255e+232, + 5.01288874827499e+234, + 6.91778647261949e+236, + 9.61572319694109e+238, + 1.34620124757175e+241, + 1.89814375907617e+243, + 2.69536413788816e+245, + 3.85437071718007e+247, + 5.5502938327393e+249, + 8.04792605747199e+251, + 1.17499720439091e+254, + 1.72724589045464e+256, + 2.55632391787286e+258, + 3.80892263763057e+260, + 5.71338395644585e+262, + 8.62720977423323e+264, + 1.31133588568345e+267, + 2.00634390509568e+269, + 3.08976961384735e+271, + 4.78914290146339e+273, + 7.47106292628289e+275, + 1.17295687942641e+278, + 1.85327186949373e+280, + 2.94670227249504e+282, + 4.71472363599206e+284, + 7.59070505394721e+286, + 1.22969421873945e+289, + 2.0044015765453e+291, + 3.28721858553429e+293, + 5.42391066613159e+295, + 9.00369170577843e+297, + 1.503616514865e+300, // nmaxfactorial = 167 +}; + +/* ---------------------------------------------------------------------- + factorial n vial lookup from precomputed table +------------------------------------------------------------------------- */ + +double MathSpecialKokkos::factorial(const int n) +{ + if (n < 0 || n > nmaxfactorial) + return std::numeric_limits::quiet_NaN(); + + return nfac_table[n]; +} + + /* Library libcerf: * Compute complex error functions, based on a new implementation of * Faddeeva's w_of_z. Also provide Dawson and Voigt functions. @@ -477,59 +668,3 @@ double MathSpecialKokkos::erfcx_y100(const double y100) return 1.0; } /* erfcx_y100 */ -/* optimizer friendly implementation of exp2(x). - * - * strategy: - * - * split argument into an integer part and a fraction: - * ipart = floor(x+0.5); - * fpart = x - ipart; - * - * compute exp2(ipart) from setting the ieee754 exponent - * compute exp2(fpart) using a pade' approximation for x in [-0.5;0.5[ - * - * the result becomes: exp2(x) = exp2(ipart) * exp2(fpart) - */ - -/* IEEE 754 double precision floating point data manipulation */ -typedef union -{ - double f; - uint64_t u; - struct {int32_t i0,i1;} s; -} udi_t; - -static const double fm_exp2_q[] = { -/* 1.00000000000000000000e0, */ - 2.33184211722314911771e2, - 4.36821166879210612817e3 -}; -static const double fm_exp2_p[] = { - 2.30933477057345225087e-2, - 2.02020656693165307700e1, - 1.51390680115615096133e3 -}; - -double MathSpecialKokkos::exp2_x86(double x) -{ - double ipart, fpart, px, qx; - udi_t epart; - - ipart = floor(x+0.5); - fpart = x - ipart; - epart.s.i0 = 0; - epart.s.i1 = (((int) ipart) + 1023) << 20; - - x = fpart*fpart; - - px = fm_exp2_p[0]; - px = px*x + fm_exp2_p[1]; - qx = x + fm_exp2_q[0]; - px = px*x + fm_exp2_p[2]; - qx = qx*x + fm_exp2_q[1]; - - px = px * fpart; - - x = 1.0 + 2.0*(px/(qx-px)); - return epart.f*x; -} diff --git a/src/KOKKOS/math_special_kokkos.h b/src/KOKKOS/math_special_kokkos.h index f2d23a65eb..0264cb4134 100644 --- a/src/KOKKOS/math_special_kokkos.h +++ b/src/KOKKOS/math_special_kokkos.h @@ -1,4 +1,3 @@ -// clang-format off /* -*- c++ -*- ---------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -15,98 +14,240 @@ #ifndef LMP_MATH_SPECIAL_KOKKOS_H #define LMP_MATH_SPECIAL_KOKKOS_H -#include #include "kokkos_type.h" +#include namespace LAMMPS_NS { namespace MathSpecialKokkos { + /*! Fast tabulated factorial function + * + * This function looks up pre-computed factorial values for arguments of n = 0 + * to a maximum of 167, which is the maximal value representable by a double + * precision floating point number. For other values of n a NaN value is returned. + * + * \param n argument (valid: 0 <= n <= 167) + * \return value of n! as double precision number or NaN */ + + extern double factorial(const int n); + + /* optimizer friendly implementation of exp2(x). + * + * strategy: + * + * split argument into an integer part and a fraction: + * ipart = floor(x+0.5); + * fpart = x - ipart; + * + * compute exp2(ipart) from setting the ieee754 exponent + * compute exp2(fpart) using a pade' approximation for x in [-0.5;0.5[ + * + * the result becomes: exp2(x) = exp2(ipart) * exp2(fpart) + */ + + /* IEEE 754 double precision floating point data manipulation */ + typedef union + { + double f; + uint64_t u; + struct {int32_t i0,i1;} s; + } udi_t; + + /* double precision constants */ + #define FM_DOUBLE_LOG2OFE 1.4426950408889634074 + + /*! Fast implementation of 2^x without argument checks for little endian CPUs + * + * This function implements an optimized version of pow(2.0, x) that does not + * check for valid arguments and thus may only be used where arguments are well + * behaved. The implementation makes assumptions about the layout of double + * precision floating point numbers in memory and thus will only work on little + * endian CPUs. If little endian cannot be safely detected, the result of + * calling pow(2.0, x) will be returned. This function also is the basis for + * the fast exponential fm_exp(x). + * + * \param x argument + * \return value of 2^x as double precision number */ + + KOKKOS_INLINE_FUNCTION + static double exp2_x86(double x) + { + #if defined(__BYTE_ORDER__) && (__BYTE_ORDER__ == __ORDER_LITTLE_ENDIAN__) + double ipart, fpart, px, qx; + udi_t epart; + + const double fm_exp2_q[2] = { + /* 1.00000000000000000000e0, */ + 2.33184211722314911771e2, + 4.36821166879210612817e3 + }; + const double fm_exp2_p[3] = { + 2.30933477057345225087e-2, + 2.02020656693165307700e1, + 1.51390680115615096133e3 + }; + + ipart = floor(x+0.5); + fpart = x - ipart; + epart.s.i0 = 0; + epart.s.i1 = (((int) ipart) + 1023) << 20; + + x = fpart*fpart; + + px = fm_exp2_p[0]; + px = px*x + fm_exp2_p[1]; + qx = x + fm_exp2_q[0]; + px = px*x + fm_exp2_p[2]; + qx = qx*x + fm_exp2_q[1]; + + px = px * fpart; + + x = 1.0 + 2.0*(px/(qx-px)); + return epart.f*x; + #else + return pow(2.0, x); + #endif + } + + /*! Fast implementation of exp(x) for little endian CPUs + * + * This function implements an optimized version of exp(x) for little endian CPUs. + * It calls the exp2_x86(x) function with a suitable prefactor to x to return exp(x). + * The implementation makes assumptions about the layout of double + * precision floating point numbers in memory and thus will only work on little + * endian CPUs. If little endian cannot be safely detected, the result of + * calling the exp(x) implementation in the standard math library will be returned. + * + * \param x argument + * \return value of e^x as double precision number */ + + KOKKOS_INLINE_FUNCTION + static double fm_exp(double x) + { + #if defined(__BYTE_ORDER__) && (__BYTE_ORDER__ == __ORDER_LITTLE_ENDIAN__) + if (x < -1022.0/FM_DOUBLE_LOG2OFE) return 0; + if (x > 1023.0/FM_DOUBLE_LOG2OFE) return INFINITY; + return exp2_x86(FM_DOUBLE_LOG2OFE * x); + #else + return ::exp(x); + #endif + } + // support function for scaled error function complement extern double erfcx_y100(const double y100); - // fast 2**x function without argument checks for little endian CPUs - extern double exp2_x86(double x); - - // scaled error function complement exp(x*x)*erfc(x) for coul/long styles + /*! Fast scaled error function complement exp(x*x)*erfc(x) for coul/long styles + * + * This is a portable fast implementation of exp(x*x)*erfc(x) that can be used + * in coul/long pair styles as a replacement for the polynomial expansion that + * is/was widely used. Unlike the polynomial expansion, that is only accurate + * at the level of single precision floating point it provides full double precision + * accuracy, but at comparable speed (unlike the erfc() implementation shipped + * with GNU standard math library). + * + * \param x argument + * \return value of e^(x*x)*erfc(x) */ static inline double my_erfcx(const double x) { - if (x >= 0.0) return erfcx_y100(400.0/(4.0+x)); - else return 2.0*exp(x*x) - erfcx_y100(400.0/(4.0-x)); + if (x >= 0.0) + return erfcx_y100(400.0 / (4.0 + x)); + else + return 2.0 * exp(x * x) - erfcx_y100(400.0 / (4.0 - x)); } - // exp(-x*x) for coul/long styles + /*! Fast implementation of exp(-x*x) for little endian CPUs for coul/long styles + * + * This function implements an optimized version of exp(-x*x) based on exp2_x86() + * for use with little endian CPUs. If little endian cannot be safely detected, + * the result of calling the exp(-x*x) implementation in the standard math + * library will be returned. + * + * \param x argument + * \return value of e^(-x*x) as double precision number */ static inline double expmsq(double x) { x *= x; - x *= 1.4426950408889634074; // log_2(e) -#if defined(__BYTE_ORDER__) && __BYTE_ORDER__ == __ORDER_LITTLE_ENDIAN__ + x *= 1.4426950408889634074; // log_2(e) +#if defined(__BYTE_ORDER__) && __BYTE_ORDER__ == __ORDER_LITTLE_ENDIAN__ return (x < 1023.0) ? exp2_x86(-x) : 0.0; #else return (x < 1023.0) ? exp2(-x) : 0.0; #endif } -#define FM_DOUBLE_LOG2OFE 1.4426950408889634074 - // fast e**x function for little endian CPUs, falls back to libc on other platforms - KOKKOS_INLINE_FUNCTION - static double fm_exp(double x) - { -#if defined(__BYTE_ORDER__) && (__BYTE_ORDER__ == __ORDER_LITTLE_ENDIAN__) - return exp2_x86(FM_DOUBLE_LOG2OFE * x); -#else - return ::exp(x); -#endif - } + /*! Fast inline version of pow(x, 2.0) + * + * \param x argument + * \return x*x */ - // x**2, use instead of pow(x,2.0) KOKKOS_INLINE_FUNCTION - static double square(const double &x) { return x*x; } + static double square(const double &x) { return x * x; } + + /*! Fast inline version of pow(x, 3.0) + * + * \param x argument + * \return x*x */ - // x**3, use instead of pow(x,3.0) KOKKOS_INLINE_FUNCTION - static double cube(const double &x) { return x*x*x; } + static double cube(const double &x) { return x * x * x; } + + /* Fast inline version of pow(-1.0, n) + * + * \param n argument (integer) + * \return -1 if n is odd, 1.0 if n is even */ - // return -1.0 for odd n, 1.0 for even n, like pow(-1.0,n) KOKKOS_INLINE_FUNCTION static double powsign(const int n) { return (n & 1) ? -1.0 : 1.0; } - // optimized version of pow(x,n) with n being integer - // up to 10x faster than pow(x,y) + /* Fast inline version of pow(x,n) for integer n + * + * This is a version of pow(x,n) optimized for n being integer. + * Speedups of up to 10x faster than pow(x,y) have been measured. + * + * \param n argument (integer) + * \return value of x^n */ KOKKOS_INLINE_FUNCTION - static double powint(const double &x, const int n) { - double yy,ww; + static double powint(const double &x, const int n) + { + double yy, ww; if (x == 0.0) return 0.0; int nn = (n > 0) ? n : -n; ww = x; - for (yy = 1.0; nn != 0; nn >>= 1, ww *=ww) + for (yy = 1.0; nn != 0; nn >>= 1, ww *= ww) if (nn & 1) yy *= ww; - return (n > 0) ? yy : 1.0/yy; + return (n > 0) ? yy : 1.0 / yy; } - // optimized version of (sin(x)/x)**n with n being a _positive_ integer + /* Fast inline version of (sin(x)/x)^n as used by PPPM kspace styles + * + * This is an optimized function to compute (sin(x)/x)^n as frequently used by PPPM. + * + * \param n argument (integer). Expected to be positive. + * \return value of (sin(x)/x)^n */ KOKKOS_INLINE_FUNCTION - static double powsinxx(const double &x, int n) { - double yy,ww; + static double powsinxx(const double &x, int n) + { + double yy, ww; if (x == 0.0) return 1.0; - ww = sin(x)/x; + ww = sin(x) / x; - for (yy = 1.0; n != 0; n >>= 1, ww *=ww) + for (yy = 1.0; n != 0; n >>= 1, ww *= ww) if (n & 1) yy *= ww; return yy; } -} -} +} // namespace MathSpecialKokkos +} // namespace LAMMPS_NS #endif diff --git a/src/KOKKOS/meam_dens_final_kokkos.h b/src/KOKKOS/meam_dens_final_kokkos.h index b44a8af3bd..4a212d3597 100644 --- a/src/KOKKOS/meam_dens_final_kokkos.h +++ b/src/KOKKOS/meam_dens_final_kokkos.h @@ -3,179 +3,148 @@ using namespace LAMMPS_NS; +/* ---------------------------------------------------------------------- */ + template void -MEAMKokkos::meam_dens_final(int nlocal, int eflag_either, int eflag_global, int eflag_atom, double* eng_vdwl, - typename ArrayTypes::t_efloat_1d eatom, int ntype, typename AT::t_int_1d_randomread type, typename AT::t_int_1d_randomread fmap, int& errorflag) +MEAMKokkos::meam_dens_final(int nlocal, int eflag_either, int eflag_global, int eflag_atom, + typename ArrayTypes::t_efloat_1d eatom, int ntype, typename AT::t_int_1d type, typename AT::t_int_1d d_map, typename AT::t_int_2d d_scale, int& errorflag, EV_FLOAT &ev_all) { EV_FLOAT ev; - ev.evdwl = *eng_vdwl; this->eflag_either = eflag_either; this->eflag_global = eflag_global; this->eflag_atom = eflag_atom; this->d_eatom = eatom; this->ntype = ntype; this->type = type; - this->fmap = fmap; + this->d_map = d_map; + this->d_scale = d_scale; - // Complete the calculation of density + Kokkos::deep_copy(d_errorflag,0); + // Complete the calculation of density + + copymode = 1; Kokkos::parallel_reduce(Kokkos::RangePolicy(0,nlocal),*this,ev); - *eng_vdwl = ev.evdwl; + ev_all.evdwl =+ ev.evdwl; + copymode = 0; + + auto h_errorflag = Kokkos::create_mirror_view_and_copy(LMPHostType(),d_errorflag); + errorflag = h_errorflag(); } +/* ---------------------------------------------------------------------- */ + template KOKKOS_INLINE_FUNCTION void MEAMKokkos::operator()(TagMEAMDensFinal, const int &i, EV_FLOAT& ev) const { - lattice_t elti; - int m; - int errorflag; F_FLOAT rhob, G, dG, Gbar, dGbar, gam, shp[3], Z; - F_FLOAT B, denom, rho_bkgd; + F_FLOAT denom, rho_bkgd, Fl; + double scaleii; - // may or may not be legal - elti = static_cast(fmap[type[i]]); - if (elti >= 0) { - d_rho1[i] = 0.0; - d_rho2[i] = -1.0 / 3.0 * d_arho2b[i] * d_arho2b[i]; - d_rho3[i] = 0.0; - for (m = 0; m < 3; m++) { - d_rho1[i] = d_rho1[i] + d_arho1(i,m) * d_arho1(i,m); - d_rho3[i] = d_rho3[i] - 3.0 / 5.0 * d_arho3b(i,m) * d_arho3b(i,m); - } - for (m = 0; m < 6; m++) { - d_rho2[i] = d_rho2[i] + v2D[m] * d_arho2(i,m) * d_arho2(i,m); - } - for (m = 0; m < 10; m++) { - d_rho3[i] = d_rho3[i] + v3D[m] * d_arho3(i,m) * d_arho3(i,m); - } + int elti = d_map[type[i]]; + if (elti >= 0) { + scaleii = d_scale(type[i],type[i]); + d_rho1[i] = 0.0; + d_rho2[i] = -1.0 / 3.0 * d_arho2b[i] * d_arho2b[i]; + d_rho3[i] = 0.0; + for (int m = 0; m < 3; m++) { + d_rho1[i] += d_arho1(i,m) * d_arho1(i,m); + d_rho3[i] -= 3.0 / 5.0 * d_arho3b(i,m) * d_arho3b(i,m); + } + for (int m = 0; m < 6; m++) + d_rho2[i] += v2D[m] * d_arho2(i,m) * d_arho2(i,m); + for (int m = 0; m < 10; m++) + d_rho3[i] += v3D[m] * d_arho3(i,m) * d_arho3(i,m); - if (d_rho0[i] > 0.0) { - if (this->ialloy == 1) { - d_t_ave(i,0) = fdiv_zero_kk(d_t_ave(i,0), d_tsq_ave(i,0)); - d_t_ave(i,1) = fdiv_zero_kk(d_t_ave(i,1), d_tsq_ave(i,1)); - d_t_ave(i,2) = fdiv_zero_kk(d_t_ave(i,2), d_tsq_ave(i,2)); - } else if (this->ialloy == 2) { - d_t_ave(i,0) = this->t1_meam[elti]; - d_t_ave(i,1) = this->t2_meam[elti]; - d_t_ave(i,2) = this->t3_meam[elti]; - } else { - d_t_ave(i,0) = d_t_ave(i,0) / d_rho0[i]; - d_t_ave(i,1) = d_t_ave(i,1) / d_rho0[i]; - d_t_ave(i,2) = d_t_ave(i,2) / d_rho0[i]; - } - } - - d_gamma[i] = d_t_ave(i,0) * d_rho1[i] + d_t_ave(i,1) * d_rho2[i] + d_t_ave(i,2) * d_rho3[i]; - - if (d_rho0[i] > 0.0) { - d_gamma[i] = d_gamma[i] / (d_rho0[i] * d_rho0[i]); - } - - // need to double check, the analogous function is - // Z = get_Zij(this->lattce_meam[elti][elti]); in the non-KOKKOS version? - Z = get_Zij(elti); - - G = G_gam(d_gamma[i], this->ibar_meam[elti], errorflag); - if (errorflag != 0) - { - //char str[128]; - //sprintf(str,"MEAMKokkos library error %d",errorflag); - //error->one(FLERR,str); - return; - } - get_shpfcn(this->lattce_meam[elti][elti], shp); - if (this->ibar_meam[elti] <= 0) { - Gbar = 1.0; - dGbar = 0.0; + if (d_rho0[i] > 0.0) { + if (ialloy == 1) { + d_t_ave(i,0) = fdiv_zero_kk(d_t_ave(i,0), d_tsq_ave(i,0)); + d_t_ave(i,1) = fdiv_zero_kk(d_t_ave(i,1), d_tsq_ave(i,1)); + d_t_ave(i,2) = fdiv_zero_kk(d_t_ave(i,2), d_tsq_ave(i,2)); + } else if (ialloy == 2) { + d_t_ave(i,0) = t1_meam[elti]; + d_t_ave(i,1) = t2_meam[elti]; + d_t_ave(i,2) = t3_meam[elti]; } else { - if (this->mix_ref_t == 1) { - gam = (d_t_ave(i,0) * shp[0] + d_t_ave(i,1) * shp[1] + d_t_ave(i,2) * shp[2]) / (Z * Z); - } else { - gam = (this->t1_meam[elti] * shp[0] + this->t2_meam[elti] * shp[1] + this->t3_meam[elti] * shp[2]) / - (Z * Z); - } - Gbar = G_gam(gam, this->ibar_meam[elti], errorflag); - } - d_rho[i] = d_rho0[i] * G; - - if (this->mix_ref_t == 1) { - if (this->ibar_meam[elti] <= 0) { - Gbar = 1.0; - dGbar = 0.0; - } else { - gam = (d_t_ave(i,0) * shp[0] + d_t_ave(i,1) * shp[1] + d_t_ave(i,2) * shp[2]) / (Z * Z); - Gbar = dG_gam(gam, this->ibar_meam[elti], dGbar); - } - rho_bkgd = this->rho0_meam[elti] * Z * Gbar; - } else { - if (this->bkgd_dyn == 1) { - rho_bkgd = this->rho0_meam[elti] * Z; - } else { - rho_bkgd = this->rho_ref_meam[elti]; - } - } - rhob = d_rho[i] / rho_bkgd; - denom = 1.0 / rho_bkgd; - - G = dG_gam(d_gamma[i], this->ibar_meam[elti], dG); - - d_dgamma1[i] = (G - 2 * dG * d_gamma[i]) * denom; - - if (!iszero_kk(d_rho0[i])) { - d_dgamma2[i] = (dG / d_rho0[i]) * denom; - } else { - d_dgamma2[i] = 0.0; - } - - // dgamma3 is nonzero only if we are using the "mixed" rule for - // computing t in the reference system (which is not correct, but - // included for backward compatibility - if (this->mix_ref_t == 1) { - d_dgamma3[i] = d_rho0[i] * G * dGbar / (Gbar * Z * Z) * denom; - } else { - d_dgamma3[i] = 0.0; - } - - B = this->A_meam[elti] * this->Ec_meam[elti][elti]; - - if (!iszero_kk(rhob)) { - if (this->emb_lin_neg == 1 && rhob <= 0) { - d_frhop[i] = -B; - } else { - d_frhop[i] = B * (log(rhob) + 1.0); - } - if (eflag_either != 0) { - if (eflag_global != 0) { - if (this->emb_lin_neg == 1 && rhob <= 0) { - //*eng_vdwl = *eng_vdwl - B * rhob; - ev.evdwl = ev.evdwl - B * rhob; - } else { - //*eng_vdwl = *eng_vdwl + B * rhob * log(rhob); - ev.evdwl = ev.evdwl + B * rhob * log(rhob); - } - } - if (eflag_atom != 0) { - if (this->emb_lin_neg == 1 && rhob <= 0) { - d_eatom[i] = d_eatom[i] - B * rhob; - } else { - d_eatom[i] = d_eatom[i] + B * rhob * log(rhob); - } - } - } - } else { - if (this->emb_lin_neg == 1) { - d_frhop[i] = -B; - } else { - d_frhop[i] = B; - } + d_t_ave(i,0) /= d_rho0[i]; + d_t_ave(i,1) /= d_rho0[i]; + d_t_ave(i,2) /= d_rho0[i]; } } - if (errorflag) - { - //char str[128]; - //sprintf(str,"MEAMKokkos library error %d",errorflag); - //error->one(FLERR,str); + + d_gamma[i] = d_t_ave(i,0) * d_rho1[i] + d_t_ave(i,1) * d_rho2[i] + d_t_ave(i,2) * d_rho3[i]; + + if (d_rho0[i] > 0.0) + d_gamma[i] /= (d_rho0[i] * d_rho0[i]); + + Z = get_Zij(lattce_meam[elti][elti]); + + G = G_gam(d_gamma[i], ibar_meam[elti], d_errorflag()); + if (d_errorflag() != 0) + return; + + get_shpfcn(lattce_meam[elti][elti], stheta_meam[elti][elti], ctheta_meam[elti][elti], shp); + if (ibar_meam[elti] <= 0) { + Gbar = 1.0; + dGbar = 0.0; + } else { + if (mix_ref_t == 1) + gam = (d_t_ave(i,0) * shp[0] + d_t_ave(i,1) * shp[1] + d_t_ave(i,2) * shp[2]) / (Z * Z); + else + gam = (t1_meam[elti] * shp[0] + t2_meam[elti] * shp[1] + t3_meam[elti] * shp[2]) / + (Z * Z); + Gbar = G_gam(gam, ibar_meam[elti], d_errorflag()); } + d_rho[i] = d_rho0[i] * G; + + if (mix_ref_t == 1) { + if (ibar_meam[elti] <= 0) { + Gbar = 1.0; + dGbar = 0.0; + } else { + gam = (d_t_ave(i,0) * shp[0] + d_t_ave(i,1) * shp[1] + d_t_ave(i,2) * shp[2]) / (Z * Z); + Gbar = dG_gam(gam, ibar_meam[elti], dGbar); + } + rho_bkgd = rho0_meam[elti] * Z * Gbar; + } else { + if (bkgd_dyn == 1) + rho_bkgd = rho0_meam[elti] * Z; + else + rho_bkgd = rho_ref_meam[elti]; + } + rhob = d_rho[i] / rho_bkgd; + denom = 1.0 / rho_bkgd; + + G = dG_gam(d_gamma[i], ibar_meam[elti], dG); + + d_dgamma1[i] = (G - 2 * dG * d_gamma[i]) * denom; + + if (!iszero_kk(d_rho0[i])) + d_dgamma2[i] = (dG / d_rho0[i]) * denom; + else + d_dgamma2[i] = 0.0; + + // dgamma3 is nonzero only if we are using the "mixed" rule for + // computing t in the reference system (which is not correct, but + // included for backward compatibility + if (mix_ref_t == 1) + d_dgamma3[i] = d_rho0[i] * G * dGbar / (Gbar * Z * Z) * denom; + else + d_dgamma3[i] = 0.0; + + Fl = embedding(A_meam[elti], Ec_meam[elti][elti], rhob, d_frhop[i]); + + if (eflag_either) { + Fl *= scaleii; + if (eflag_global) { + ev.evdwl += Fl; + } + if (eflag_atom) { + d_eatom[i] += Fl; + } + } + } } + diff --git a/src/KOKKOS/meam_dens_init_kokkos.h b/src/KOKKOS/meam_dens_init_kokkos.h index c3dfdbbcb8..bcf0e7433e 100644 --- a/src/KOKKOS/meam_dens_init_kokkos.h +++ b/src/KOKKOS/meam_dens_init_kokkos.h @@ -1,41 +1,45 @@ #include "meam_kokkos.h" -#include "math_special.h" -#include "mpi.h" +#include "math_special_kokkos.h" using namespace LAMMPS_NS; using namespace MathSpecialKokkos; +/* ---------------------------------------------------------------------- */ + template template KOKKOS_INLINE_FUNCTION -void MEAMKokkos::operator()(TagMEAMDensInit, const int &i, EV_FLOAT &ev) const { +void MEAMKokkos::operator()(TagMEAMDensInit, const int &i) const { int ii, offsetval; ii = d_ilist_half[i]; offsetval = d_offset[i]; - // Compute screening function and derivatives + // compute screening function and derivatives this->template getscreen(ii, offsetval, x, d_numneigh_half, - d_numneigh_full, ntype, type, fmap); + d_numneigh_full, ntype, type, d_map); - // Calculate intermediate density terms to be communicated - this->template calc_rho1(ii, ntype, type, fmap, x, d_numneigh_half, offsetval); - ev.evdwl += d_numneigh_half[i]; + // calculate intermediate density terms to be communicated + this->template calc_rho1(ii, ntype, type, d_map, x, d_numneigh_half, offsetval); } +/* ---------------------------------------------------------------------- */ + template KOKKOS_INLINE_FUNCTION -void MEAMKokkos::operator()(TagMEAMInitialize, const int &i) const { - d_rho0[i] = 0.0; - d_arho2b[i] = 0.0; - d_arho1(i,0) = d_arho1(i,1) = d_arho1(i,2) = 0.0; - for (int j = 0; j < 6; j++) - d_arho2(i,j) = 0.0; - for (int j = 0; j < 10; j++) - d_arho3(i,j) = 0.0; - d_arho3b(i,0) = d_arho3b(i,1) = d_arho3b(i,2) = 0.0; - d_t_ave(i,0) = d_t_ave(i,1) = d_t_ave(i,2) = 0.0; - d_tsq_ave(i,0) = d_tsq_ave(i,1) = d_tsq_ave(i,2) = 0.0; +void MEAMKokkos::operator()(TagMEAMZero, const int &i) const { + d_rho0[i] = 0.0; + d_arho2b[i] = 0.0; + d_arho1(i,0) = d_arho1(i,1) = d_arho1(i,2) = 0.0; + for (int j = 0; j < 6; j++) + d_arho2(i,j) = 0.0; + for (int j = 0; j < 10; j++) + d_arho3(i,j) = 0.0; + d_arho3b(i,0) = d_arho3b(i,1) = d_arho3b(i,2) = 0.0; + d_t_ave(i,0) = d_t_ave(i,1) = d_t_ave(i,2) = 0.0; + d_tsq_ave(i,0) = d_tsq_ave(i,1) = d_tsq_ave(i,2) = 0.0; } +/* ---------------------------------------------------------------------- */ + template void MEAMKokkos::meam_dens_setup(int atom_nmax, int nall, int n_neigh) @@ -155,20 +159,21 @@ MEAMKokkos::meam_dens_setup(int atom_nmax, int nall, int n_neigh) // zero out local arrays - Kokkos::parallel_for(Kokkos::RangePolicy(0, nall),*this); + copymode = 1; + Kokkos::parallel_for(Kokkos::RangePolicy(0, nall),*this); + copymode = 0; } +/* ---------------------------------------------------------------------- */ + template void -MEAMKokkos::meam_dens_init(int inum_half, int ntype, typename AT::t_int_1d_randomread type, typename AT::t_int_1d_randomread fmap, typename AT::t_x_array_randomread x, typename AT::t_int_1d_randomread d_numneigh_half, typename AT::t_int_1d_randomread d_numneigh_full, - int *fnoffset, typename AT::t_int_1d_randomread d_ilist_half, typename AT::t_neighbors_2d d_neighbors_half, typename AT::t_neighbors_2d d_neighbors_full, typename AT::t_int_1d_randomread d_offset, int neighflag) +MEAMKokkos::meam_dens_init(int inum_half, int ntype, typename AT::t_int_1d type, typename AT::t_int_1d d_map, typename AT::t_x_array x, typename AT::t_int_1d d_numneigh_half, typename AT::t_int_1d d_numneigh_full, + typename AT::t_int_1d d_ilist_half, typename AT::t_neighbors_2d d_neighbors_half, typename AT::t_neighbors_2d d_neighbors_full, typename AT::t_int_1d d_offset, int neighflag, int need_dup) { - EV_FLOAT ev; - - ev.evdwl = 0; this->ntype = ntype; this->type = type; - this->fmap = fmap; + this->d_map = d_map; this->x = x; this->d_numneigh_half = d_numneigh_half; this->d_numneigh_full = d_numneigh_full; @@ -176,298 +181,325 @@ MEAMKokkos::meam_dens_init(int inum_half, int ntype, typename AT::t_ this->d_neighbors_half = d_neighbors_half; this->d_neighbors_full = d_neighbors_full; this->d_offset = d_offset; - if (neighflag == FULL) - Kokkos::parallel_reduce(Kokkos::RangePolicy >(0,inum_half),*this, ev); - else if (neighflag == HALF) - Kokkos::parallel_reduce(Kokkos::RangePolicy >(0,inum_half),*this, ev); + this->nlocal = nlocal; + + if (need_dup) { + dup_rho0 = Kokkos::Experimental::create_scatter_view(d_rho0); + dup_arho2b = Kokkos::Experimental::create_scatter_view(d_arho2b); + dup_arho1 = Kokkos::Experimental::create_scatter_view(d_arho1); + dup_arho2 = Kokkos::Experimental::create_scatter_view(d_arho2); + dup_arho3 = Kokkos::Experimental::create_scatter_view(d_arho3); + dup_arho3b = Kokkos::Experimental::create_scatter_view(d_arho3b); + dup_t_ave = Kokkos::Experimental::create_scatter_view(d_t_ave); + dup_tsq_ave = Kokkos::Experimental::create_scatter_view(d_tsq_ave); + } else { + ndup_rho0 = Kokkos::Experimental::create_scatter_view(d_rho0); + ndup_arho2b = Kokkos::Experimental::create_scatter_view(d_arho2b); + ndup_arho1 = Kokkos::Experimental::create_scatter_view(d_arho1); + ndup_arho2 = Kokkos::Experimental::create_scatter_view(d_arho2); + ndup_arho3 = Kokkos::Experimental::create_scatter_view(d_arho3); + ndup_arho3b = Kokkos::Experimental::create_scatter_view(d_arho3b); + ndup_t_ave = Kokkos::Experimental::create_scatter_view(d_t_ave); + ndup_tsq_ave = Kokkos::Experimental::create_scatter_view(d_tsq_ave); + } + + copymode = 1; + if (neighflag == HALF) + Kokkos::parallel_for(Kokkos::RangePolicy >(0,inum_half),*this); else if (neighflag == HALFTHREAD) - Kokkos::parallel_reduce(Kokkos::RangePolicy >(0,inum_half),*this, ev); - *fnoffset = (int)ev.evdwl; + Kokkos::parallel_for(Kokkos::RangePolicy >(0,inum_half),*this); + copymode = 0; + + if (need_dup) { + Kokkos::Experimental::contribute(d_rho0, dup_rho0); + Kokkos::Experimental::contribute(d_arho2b, dup_arho2b); + Kokkos::Experimental::contribute(d_arho1, dup_arho1); + Kokkos::Experimental::contribute(d_arho2, dup_arho2); + Kokkos::Experimental::contribute(d_arho3, dup_arho3); + Kokkos::Experimental::contribute(d_arho3b, dup_arho3b); + Kokkos::Experimental::contribute(d_t_ave, dup_t_ave); + Kokkos::Experimental::contribute(d_tsq_ave, dup_tsq_ave); + + // free duplicated memory + dup_rho0 = decltype(dup_rho0)(); + dup_arho2b = decltype(dup_arho2b)(); + dup_arho1 = decltype(dup_arho1)(); + dup_arho2 = decltype(dup_arho2)(); + dup_arho3 = decltype(dup_arho3)(); + dup_arho3b = decltype(dup_arho3b)(); + dup_t_ave = decltype(dup_t_ave)(); + dup_tsq_ave = decltype(dup_tsq_ave)(); + } } -// ccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccc +/* ---------------------------------------------------------------------- */ + template template KOKKOS_INLINE_FUNCTION void -MEAMKokkos::getscreen(int i, int offset, typename AT::t_x_array_randomread x, typename AT::t_int_1d_randomread numneigh_half, - typename AT::t_int_1d_randomread numneigh_full, int /*ntype*/, typename AT::t_int_1d_randomread type, typename AT::t_int_1d_randomread fmap) +MEAMKokkos::getscreen(int i, int offset, typename AT::t_x_array x, typename AT::t_int_1d d_numneigh_half, + typename AT::t_int_1d d_numneigh_full, int /*ntype*/, typename AT::t_int_1d type, typename AT::t_int_1d d_map) const { - int jn, j, kn, k; - int elti, eltj, eltk; - X_FLOAT xitmp, yitmp, zitmp, delxij, delyij, delzij; - F_FLOAT rij2, rij; - X_FLOAT xjtmp, yjtmp, zjtmp, delxik, delyik, delzik; - F_FLOAT rik2 /*,rik*/; - X_FLOAT xktmp, yktmp, zktmp, delxjk, delyjk, delzjk; - F_FLOAT rjk2 /*,rjk*/; - X_FLOAT xik, xjk; - F_FLOAT sij, fcij, sfcij, dfcij, sikj, dfikj, cikj; - F_FLOAT Cmin, Cmax, delc, /*ebound,*/ a, coef1, coef2; - F_FLOAT dCikj; - F_FLOAT rnorm, fc, dfc, drinv; - - drinv = 1.0 / this->delr_meam; - elti = fmap[type[i]]; + const double drinv = 1.0 / delr_meam; + const int elti = d_map[type[i]]; if (elti < 0) return; - xitmp = x(i,0); - yitmp = x(i,1); - zitmp = x(i,2); + const double xitmp = x(i,0); + const double yitmp = x(i,1); + const double zitmp = x(i,2); - for (jn = 0; jn < numneigh_half[i]; jn++) { - //j = firstneigh[jn]; - j = d_neighbors_half(i,jn); + for (int jn = 0; jn < d_numneigh_half[i]; jn++) { + const int j = d_neighbors_half(i,jn); - eltj = fmap[type[j]]; + const int eltj = d_map[type[j]]; if (eltj < 0) continue; - // First compute screening function itself, sij - xjtmp = x(j,0); - yjtmp = x(j,1); - zjtmp = x(j,2); - delxij = xjtmp - xitmp; - delyij = yjtmp - yitmp; - delzij = zjtmp - zitmp; + // First compute screening function itself, sij + const double xjtmp = x(j,0); + const double yjtmp = x(j,1); + const double zjtmp = x(j,2); + const double delxij = xjtmp - xitmp; + const double delyij = yjtmp - yitmp; + const double delzij = zjtmp - zitmp; - rij2 = delxij * delxij + delyij * delyij + delzij * delzij; - rij = sqrt(rij2); + const double rij2 = delxij * delxij + delyij * delyij + delzij * delzij; - double rbound = this->ebound_meam[elti][eltj] * rij2; - if (rij > this->rc_meam) { - fcij = 0.0; - dfcij = 0.0; - sij = 0.0; - } else { - rnorm = (this->rc_meam - rij) * drinv; - sij = 1.0; - - // if rjk2 > ebound*rijsq, atom k is definitely outside the ellipse - for (kn = 0; kn < numneigh_full[i]; kn++) { - //k = firstneigh_full[kn]; - k = d_neighbors_full(i,kn); - eltk = fmap[type[k]]; - if (eltk < 0) continue; - if (k == j) continue; - - delxjk = x(k,0) - xjtmp; - delyjk = x(k,1) - yjtmp; - delzjk = x(k,2) - zjtmp; - rjk2 = delxjk * delxjk + delyjk * delyjk + delzjk * delzjk; - if (rjk2 > rbound) continue; - - delxik = x(k,0) - xitmp; - delyik = x(k,1) - yitmp; - delzik = x(k,2) - zitmp; - rik2 = delxik * delxik + delyik * delyik + delzik * delzik; - if (rik2 > rbound) continue; - - xik = rik2 / rij2; - xjk = rjk2 / rij2; - a = 1 - (xik - xjk) * (xik - xjk); - // if a < 0, then ellipse equation doesn't describe this case and - // atom k can't possibly screen i-j - if (a <= 0.0) continue; - - cikj = (2.0 * (xik + xjk) + a - 2.0) / a; - Cmax = this->Cmax_meam[elti][eltj][eltk]; - Cmin = this->Cmin_meam[elti][eltj][eltk]; - if (cikj >= Cmax) continue; - // note that cikj may be slightly negative (within numerical - // tolerance) if atoms are colinear, so don't reject that case here - // (other negative cikj cases were handled by the test on "a" above) - else if (cikj <= Cmin) { - sij = 0.0; - break; - } else { - delc = Cmax - Cmin; - cikj = (cikj - Cmin) / delc; - sikj = fcut(cikj); - } - sij *= sikj; - } - - fc = dfcut(rnorm, dfc); - fcij = fc; - dfcij = dfc * drinv; - } - // Now compute derivatives - d_dscrfcn[offset+jn] = 0.0; - sfcij = sij * fcij; - if (iszero_kk(sfcij) || iszero_kk(sfcij - 1.0)) - { - d_scrfcn[offset+jn] = sij; - d_fcpair[offset+jn] = fcij; + if (rij2 > cutforcesq) { + d_dscrfcn[offset+jn] = 0.0; + d_scrfcn[offset+jn] = 0.0; + d_fcpair[offset+jn] = 0.0; continue; - //goto LABEL_100; } - for (kn = 0; kn < numneigh_full[i]; kn++) { - //k = firstneigh_full[kn]; - k = d_neighbors_full(i,kn); + // Now compute derivatives + const double rbound = ebound_meam[elti][eltj] * rij2; + const double rij = sqrt(rij2); + const double rnorm = (cutforce - rij) * drinv; + double sij = 1.0; + + // if rjk2 > ebound*rijsq, atom k is definitely outside the ellipse + for (int kn = 0; kn < d_numneigh_full[i]; kn++) { + int k = d_neighbors_full(i,kn); if (k == j) continue; - eltk = fmap[type[k]]; + int eltk = d_map[type[k]]; if (eltk < 0) continue; - xktmp = x(k,0); - yktmp = x(k,1); - zktmp = x(k,2); - delxjk = xktmp - xjtmp; - delyjk = yktmp - yjtmp; - delzjk = zktmp - zjtmp; - rjk2 = delxjk * delxjk + delyjk * delyjk + delzjk * delzjk; + const double xktmp = x(k,0); + const double yktmp = x(k,1); + const double zktmp = x(k,2); + + const double delxjk = xktmp - xjtmp; + const double delyjk = yktmp - yjtmp; + const double delzjk = zktmp - zjtmp; + const double rjk2 = delxjk * delxjk + delyjk * delyjk + delzjk * delzjk; if (rjk2 > rbound) continue; - delxik = xktmp - xitmp; - delyik = yktmp - yitmp; - delzik = zktmp - zitmp; - rik2 = delxik * delxik + delyik * delyik + delzik * delzik; + const double delxik = xktmp - xitmp; + const double delyik = yktmp - yitmp; + const double delzik = zktmp - zitmp; + const double rik2 = delxik * delxik + delyik * delyik + delzik * delzik; if (rik2 > rbound) continue; - xik = rik2 / rij2; - xjk = rjk2 / rij2; - a = 1 - (xik - xjk) * (xik - xjk); - // if a < 0, then ellipse equation doesn't describe this case and - // atom k can't possibly screen i-j + const double xik = rik2 / rij2; + const double xjk = rjk2 / rij2; + const double a = 1 - (xik - xjk) * (xik - xjk); + // if a < 0, then ellipse equation doesn't describe this case and + // atom k can't possibly screen i-j if (a <= 0.0) continue; - cikj = (2.0 * (xik + xjk) + a - 2.0) / a; - Cmax = this->Cmax_meam[elti][eltj][eltk]; - Cmin = this->Cmin_meam[elti][eltj][eltk]; - if (cikj >= Cmax) { - continue; - // Note that cikj may be slightly negative (within numerical - // tolerance) if atoms are colinear, so don't reject that case - // here - // (other negative cikj cases were handled by the test on "a" - // above) - // Note that we never have 0= Cmax) continue; + // note that cikj may be slightly negative (within numerical + // tolerance) if atoms are colinear, so don't reject that case here + // (other negative cikj cases were handled by the test on "a" above) + else if (cikj <= Cmin) { + sij = 0.0; + break; } else { - delc = Cmax - Cmin; + const double delc = Cmax - Cmin; cikj = (cikj - Cmin) / delc; - sikj = dfcut(cikj, dfikj); - coef1 = dfikj / (delc * sikj); - dCikj = dCfunc(rij2, rik2, rjk2); - d_dscrfcn[offset+jn] = d_dscrfcn[offset+jn] + coef1 * dCikj; + sikj = fcut(cikj); } + sij *= sikj; + } + + double dfc; + const double fc = dfcut(rnorm, dfc); + const double fcij = fc; + const double dfcij = dfc * drinv; + + // Now compute derivatives + d_dscrfcn[offset+jn] = 0.0; + const double sfcij = sij * fcij; + if (!iszero_kk(sfcij) && !isone_kk(sfcij)) { + for (int kn = 0; kn < d_numneigh_full[i]; kn++) { + const int k = d_neighbors_full(i,kn); + if (k == j) continue; + const int eltk = d_map[type[k]]; + if (eltk < 0) continue; + + const double delxjk = x(k,0) - xjtmp; + const double delyjk = x(k,1) - yjtmp; + const double delzjk = x(k,2) - zjtmp; + const double rjk2 = delxjk * delxjk + delyjk * delyjk + delzjk * delzjk; + if (rjk2 > rbound) continue; + + const double delxik = x(k,0) - xitmp; + const double delyik = x(k,1) - yitmp; + const double delzik = x(k,2) - zitmp; + const double rik2 = delxik * delxik + delyik * delyik + delzik * delzik; + if (rik2 > rbound) continue; + + const double xik = rik2 / rij2; + const double xjk = rjk2 / rij2; + const double a = 1 - (xik - xjk) * (xik - xjk); + // if a < 0, then ellipse equation doesn't describe this case and + // atom k can't possibly screen i-j + if (a <= 0.0) continue; + + double cikj = (2.0 * (xik + xjk) + a - 2.0) / a; + const double Cmax = Cmax_meam[elti][eltj][eltk]; + const double Cmin = Cmin_meam[elti][eltj][eltk]; + if (cikj >= Cmax) { + continue; + // Note that cikj may be slightly negative (within numerical + // tolerance) if atoms are colinear, so don't reject that case + // here + // (other negative cikj cases were handled by the test on "a" + // above) + // Note that we never have 0 template KOKKOS_INLINE_FUNCTION void -MEAMKokkos::calc_rho1(int i, int /*ntype*/, typename AT::t_int_1d_randomread type, typename AT::t_int_1d_randomread fmap, typename AT::t_x_array_randomread x, typename AT::t_int_1d_randomread numneigh, +MEAMKokkos::calc_rho1(int i, int /*ntype*/, typename AT::t_int_1d type, typename AT::t_int_1d d_map, typename AT::t_x_array x, typename AT::t_int_1d d_numneigh, int offset) const { - int jn, j, m, n, p, elti, eltj; - int nv2, nv3; - X_FLOAT xtmp, ytmp, ztmp, delij[3]; - F_FLOAT rij2, rij, sij; - F_FLOAT ai, aj, rhoa0j, rhoa1j, rhoa2j, rhoa3j, A1j, A2j, A3j; - // double G,Gbar,gam,shp[3+1]; - F_FLOAT ro0i, ro0j; - F_FLOAT rhoa0i, rhoa1i, rhoa2i, rhoa3i, A1i, A2i, A3i; + // The rho0, etc. arrays are duplicated for OpenMP, atomic for CUDA, and neither for Serial - // Likely to do: replace with duplicated view for OpenMP, atomic view for GPU abstraction - Kokkos::View::value> > a_rho0 = d_rho0; - Kokkos::View::value> > a_arho2b = d_arho2b; - Kokkos::View::value> > a_t_ave = d_t_ave; - Kokkos::View::value> > a_tsq_ave = d_tsq_ave; - Kokkos::View::value> > a_arho1 = d_arho1; - Kokkos::View::value> > a_arho2 = d_arho2; - Kokkos::View::value> > a_arho3 = d_arho3; - Kokkos::View::value> > a_arho3b = d_arho3b; + auto v_rho0 = ScatterViewHelper,decltype(dup_rho0),decltype(ndup_rho0)>::get(dup_rho0,ndup_rho0); + auto a_rho0 = v_rho0.template access>(); + auto v_arho2b = ScatterViewHelper,decltype(dup_arho2b),decltype(ndup_arho2b)>::get(dup_arho2b,ndup_arho2b); + auto a_arho2b = v_arho2b.template access>(); + auto v_arho1 = ScatterViewHelper,decltype(dup_arho1),decltype(ndup_arho1)>::get(dup_arho1,ndup_arho1); + auto a_arho1 = v_arho1.template access>(); + auto v_arho2 = ScatterViewHelper,decltype(dup_arho2),decltype(ndup_arho2)>::get(dup_arho2,ndup_arho2); + auto a_arho2 = v_arho2.template access>(); + auto v_arho3 = ScatterViewHelper,decltype(dup_arho3),decltype(ndup_arho3)>::get(dup_arho3,ndup_arho3); + auto a_arho3 = v_arho3.template access>(); + auto v_arho3b = ScatterViewHelper,decltype(dup_arho3b),decltype(ndup_arho3b)>::get(dup_arho3b,ndup_arho3b); + auto a_arho3b = v_arho3b.template access>(); + auto v_t_ave = ScatterViewHelper,decltype(dup_t_ave),decltype(ndup_t_ave)>::get(dup_t_ave,ndup_t_ave); + auto a_t_ave = v_t_ave.template access>(); + auto v_tsq_ave = ScatterViewHelper,decltype(dup_tsq_ave),decltype(ndup_tsq_ave)>::get(dup_tsq_ave,ndup_tsq_ave); + auto a_tsq_ave = v_tsq_ave.template access>(); - elti = fmap[type[i]]; - xtmp = x(i,0); - ytmp = x(i,1); - ztmp = x(i,2); - for (jn = 0; jn < numneigh[i]; jn++) { + const int elti = d_map[type[i]]; + const double xtmp = x(i,0); + const double ytmp = x(i,1); + const double ztmp = x(i,2); + for (int jn = 0; jn < d_numneigh[i]; jn++) { if (!iszero_kk(d_scrfcn[offset+jn])) { - //j = firstneigh[jn]; - j = d_neighbors_half(i,jn); - sij = d_scrfcn[offset+jn] * d_fcpair[offset+jn]; + const int j = d_neighbors_half(i,jn); + const double sij = d_scrfcn[offset+jn] * d_fcpair[offset+jn]; + double delij[3]; delij[0] = x(j,0) - xtmp; delij[1] = x(j,1) - ytmp; delij[2] = x(j,2) - ztmp; - rij2 = delij[0] * delij[0] + delij[1] * delij[1] + delij[2] * delij[2]; - if (rij2 < this->cutforcesq) { - eltj = fmap[type[j]]; - rij = sqrt(rij2); - ai = rij / this->re_meam[elti][elti] - 1.0; - aj = rij / this->re_meam[eltj][eltj] - 1.0; - ro0i = this->rho0_meam[elti]; - ro0j = this->rho0_meam[eltj]; - rhoa0j = ro0j * MathSpecialKokkos::fm_exp(-this->beta0_meam[eltj] * aj) * sij; - rhoa1j = ro0j * MathSpecialKokkos::fm_exp(-this->beta1_meam[eltj] * aj) * sij; - rhoa2j = ro0j * MathSpecialKokkos::fm_exp(-this->beta2_meam[eltj] * aj) * sij; - rhoa3j = ro0j * MathSpecialKokkos::fm_exp(-this->beta3_meam[eltj] * aj) * sij; - rhoa0i = ro0i * MathSpecialKokkos::fm_exp(-this->beta0_meam[elti] * ai) * sij; - rhoa1i = ro0i * MathSpecialKokkos::fm_exp(-this->beta1_meam[elti] * ai) * sij; - rhoa2i = ro0i * MathSpecialKokkos::fm_exp(-this->beta2_meam[elti] * ai) * sij; - rhoa3i = ro0i * MathSpecialKokkos::fm_exp(-this->beta3_meam[elti] * ai) * sij; - if (this->ialloy == 1) { - rhoa1j = rhoa1j * this->t1_meam[eltj]; - rhoa2j = rhoa2j * this->t2_meam[eltj]; - rhoa3j = rhoa3j * this->t3_meam[eltj]; - rhoa1i = rhoa1i * this->t1_meam[elti]; - rhoa2i = rhoa2i * this->t2_meam[elti]; - rhoa3i = rhoa3i * this->t3_meam[elti]; + const double rij2 = delij[0] * delij[0] + delij[1] * delij[1] + delij[2] * delij[2]; + if (rij2 < cutforcesq) { + const int eltj = d_map[type[j]]; + const double rij = sqrt(rij2); + const double ai = rij / re_meam[elti][elti] - 1.0; + const double aj = rij / re_meam[eltj][eltj] - 1.0; + const double ro0i = rho0_meam[elti]; + const double ro0j = rho0_meam[eltj]; + const double rhoa0j = ro0j * MathSpecialKokkos::fm_exp(-beta0_meam[eltj] * aj) * sij; + double rhoa1j = ro0j * MathSpecialKokkos::fm_exp(-beta1_meam[eltj] * aj) * sij; + double rhoa2j = ro0j * MathSpecialKokkos::fm_exp(-beta2_meam[eltj] * aj) * sij; + double rhoa3j = ro0j * MathSpecialKokkos::fm_exp(-beta3_meam[eltj] * aj) * sij; + const double rhoa0i = ro0i * MathSpecialKokkos::fm_exp(-beta0_meam[elti] * ai) * sij; + double rhoa1i = ro0i * MathSpecialKokkos::fm_exp(-beta1_meam[elti] * ai) * sij; + double rhoa2i = ro0i * MathSpecialKokkos::fm_exp(-beta2_meam[elti] * ai) * sij; + double rhoa3i = ro0i * MathSpecialKokkos::fm_exp(-beta3_meam[elti] * ai) * sij; + if (ialloy == 1) { + rhoa1j *= t1_meam[eltj]; + rhoa2j *= t2_meam[eltj]; + rhoa3j *= t3_meam[eltj]; + rhoa1i *= t1_meam[elti]; + rhoa2i *= t2_meam[elti]; + rhoa3i *= t3_meam[elti]; } a_rho0[i] += rhoa0j; a_rho0[j] += rhoa0i; // For ialloy = 2, use single-element value (not average) - if (this->ialloy != 2) { - a_t_ave(i,0) = a_t_ave(i,0) + this->t1_meam[eltj] * rhoa0j; - a_t_ave(i,1) = a_t_ave(i,1) + this->t2_meam[eltj] * rhoa0j; - a_t_ave(i,2) = a_t_ave(i,2) + this->t3_meam[eltj] * rhoa0j; - a_t_ave(j,0) = a_t_ave(j,0) + this->t1_meam[elti] * rhoa0i; - a_t_ave(j,1) = a_t_ave(j,1) + this->t2_meam[elti] * rhoa0i; - a_t_ave(j,2) = a_t_ave(j,2) + this->t3_meam[elti] * rhoa0i; + if (ialloy != 2) { + a_t_ave(i,0) += t1_meam[eltj] * rhoa0j; + a_t_ave(i,1) += t2_meam[eltj] * rhoa0j; + a_t_ave(i,2) += t3_meam[eltj] * rhoa0j; + a_t_ave(j,0) += t1_meam[elti] * rhoa0i; + a_t_ave(j,1) += t2_meam[elti] * rhoa0i; + a_t_ave(j,2) += t3_meam[elti] * rhoa0i; } - if (this->ialloy == 1) { - a_tsq_ave(i,0) = a_tsq_ave(i,0) + this->t1_meam[eltj] * this->t1_meam[eltj] * rhoa0j; - a_tsq_ave(i,1) = a_tsq_ave(i,1) + this->t2_meam[eltj] * this->t2_meam[eltj] * rhoa0j; - a_tsq_ave(i,2) = a_tsq_ave(i,2) + this->t3_meam[eltj] * this->t3_meam[eltj] * rhoa0j; - a_tsq_ave(j,0) = a_tsq_ave(j,0) + this->t1_meam[elti] * this->t1_meam[elti] * rhoa0i; - a_tsq_ave(j,1) = a_tsq_ave(j,1) + this->t2_meam[elti] * this->t2_meam[elti] * rhoa0i; - a_tsq_ave(j,2) = a_tsq_ave(j,2) + this->t3_meam[elti] * this->t3_meam[elti] * rhoa0i; + if (ialloy == 1) { + a_tsq_ave(i,0) += t1_meam[eltj] * t1_meam[eltj] * rhoa0j; + a_tsq_ave(i,1) += t2_meam[eltj] * t2_meam[eltj] * rhoa0j; + a_tsq_ave(i,2) += t3_meam[eltj] * t3_meam[eltj] * rhoa0j; + a_tsq_ave(j,0) += t1_meam[elti] * t1_meam[elti] * rhoa0i; + a_tsq_ave(j,1) += t2_meam[elti] * t2_meam[elti] * rhoa0i; + a_tsq_ave(j,2) += t3_meam[elti] * t3_meam[elti] * rhoa0i; } a_arho2b[i] += rhoa2j; a_arho2b[j] += rhoa2i; - A1j = rhoa1j / rij; - A2j = rhoa2j / rij2; - A3j = rhoa3j / (rij2 * rij); - A1i = rhoa1i / rij; - A2i = rhoa2i / rij2; - A3i = rhoa3i / (rij2 * rij); - nv2 = 0; - nv3 = 0; - for (m = 0; m < 3; m++) { + const double A1j = rhoa1j / rij; + const double A2j = rhoa2j / rij2; + const double A3j = rhoa3j / (rij2 * rij); + const double A1i = rhoa1i / rij; + const double A2i = rhoa2i / rij2; + const double A3i = rhoa3i / (rij2 * rij); + int nv2 = 0; + int nv3 = 0; + for (int m = 0; m < 3; m++) { a_arho1(i,m) += A1j * delij[m]; - a_arho1(j,m) += (-A1i * delij[m]); + a_arho1(j,m) += -A1i * delij[m]; a_arho3b(i,m) += rhoa3j * delij[m] / rij; - a_arho3b(j,m) += (- rhoa3i * delij[m] / rij); - for (n = m; n < 3; n++) { + a_arho3b(j,m) += -rhoa3i * delij[m] / rij; + for (int n = m; n < 3; n++) { a_arho2(i,nv2) += A2j * delij[m] * delij[n]; a_arho2(j,nv2) += A2i * delij[m] * delij[n]; - nv2 = nv2 + 1; - for (p = n; p < 3; p++) { + nv2++; + for (int p = n; p < 3; p++) { a_arho3(i,nv3) += A3j * delij[m] * delij[n] * delij[p]; - a_arho3(j,nv3) += (- A3i * delij[m] * delij[n] * delij[p]); - nv3 = nv3 + 1; + a_arho3(j,nv3) += -A3i * delij[m] * delij[n] * delij[p]; + nv3++; } } } @@ -476,79 +508,81 @@ MEAMKokkos::calc_rho1(int i, int /*ntype*/, typename AT::t_int_1d_ra } } +/* ---------------------------------------------------------------------- */ + //Cutoff function and derivative template KOKKOS_INLINE_FUNCTION -double MEAMKokkos::dfcut(const double xi, double& dfc) const { - double a, a3, a4, a1m4; - if (xi >= 1.0) { - dfc = 0.0; - return 1.0; - } else if (xi <= 0.0) { - dfc = 0.0; - return 0.0; - } else { - a = 1.0 - xi; - a3 = a * a * a; - a4 = a * a3; - a1m4 = 1.0-a4; +double MEAMKokkos::dfcut(const double xi, double& dfc) const +{ + if (xi >= 1.0) { + dfc = 0.0; + return 1.0; + } else if (xi <= 0.0) { + dfc = 0.0; + return 0.0; + } else { + const double a = 1.0 - xi; + const double a3 = a * a * a; + const double a4 = a * a3; + const double a1m4 = 1.0 - a4; - dfc = 8 * a1m4 * a3; - return a1m4*a1m4; - } + dfc = 8 * a1m4 * a3; + return a1m4*a1m4; } +} //----------------------------------------------------------------------------- - // // Derivative of Cikj w.r.t. rij - // // Inputs: rij,rij2,rik2,rjk2 - // // - // + // Derivative of Cikj w.r.t. rij + // Inputs: rij,rij2,rik2,rjk2 template KOKKOS_INLINE_FUNCTION double MEAMKokkos::dCfunc(const double rij2, const double rik2, const double rjk2) const { - double rij4, a, asq, b,denom; - - rij4 = rij2 * rij2; - a = rik2 - rjk2; - b = rik2 + rjk2; - asq = a*a; - denom = rij4 - asq; - denom = denom * denom; - return -4 * (-2 * rij2 * asq + rij4 * b + asq * b) / denom; + const double rij4 = rij2 * rij2; + const double a = rik2 - rjk2; + const double b = rik2 + rjk2; + const double asq = a*a; + double denom = rij4 - asq; + denom = denom * denom; + return -4 * (-2 * rij2 * asq + rij4 * b + asq * b) / denom; } +/* ---------------------------------------------------------------------- */ + template KOKKOS_INLINE_FUNCTION void MEAMKokkos::dCfunc2(const double rij2, const double rik2, const double rjk2, double& dCikj1, double& dCikj2) const { - double rij4, rik4, rjk4, a, denom; - - rij4 = rij2 * rij2; - rik4 = rik2 * rik2; - rjk4 = rjk2 * rjk2; - a = rik2 - rjk2; - denom = rij4 - a * a; - denom = denom * denom; - dCikj1 = 4 * rij2 * (rij4 + rik4 + 2 * rik2 * rjk2 - 3 * rjk4 - 2 * rij2 * a) / denom; - dCikj2 = 4 * rij2 * (rij4 - 3 * rik4 + 2 * rik2 * rjk2 + rjk4 + 2 * rij2 * a) / denom; - + const double rij4 = rij2 * rij2; + const double rik4 = rik2 * rik2; + const double rjk4 = rjk2 * rjk2; + const double a = rik2 - rjk2; + double denom = rij4 - a * a; + denom = denom * denom; + dCikj1 = 4 * rij2 * (rij4 + rik4 + 2 * rik2 * rjk2 - 3 * rjk4 - 2 * rij2 * a) / denom; + dCikj2 = 4 * rij2 * (rij4 - 3 * rik4 + 2 * rik2 * rjk2 + rjk4 + 2 * rij2 * a) / denom; } + +/* ---------------------------------------------------------------------- */ + template KOKKOS_INLINE_FUNCTION -double MEAMKokkos::fcut(const double xi) const{ - double a; - if (xi >= 1.0) - return 1.0; - else if (xi <= 0.0) - return 0.0; - else { - a = 1.0 - xi; - a *= a; a *= a; - a = 1.0 - a; - return a * a; - } +double MEAMKokkos::fcut(const double xi) const +{ + double a; + if (xi >= 1.0) + return 1.0; + else if (xi <= 0.0) + return 0.0; + else { + // ( 1.d0 - (1.d0 - xi)**4 )**2, but with better codegen + a = 1.0 - xi; + a *= a; a *= a; + a = 1.0 - a; + return a * a; } +} diff --git a/src/KOKKOS/meam_force_kokkos.h b/src/KOKKOS/meam_force_kokkos.h index 4e061c9043..aafcf80473 100644 --- a/src/KOKKOS/meam_force_kokkos.h +++ b/src/KOKKOS/meam_force_kokkos.h @@ -5,106 +5,129 @@ using namespace LAMMPS_NS; using namespace MathSpecialKokkos; - template void -MEAMKokkos::meam_force(int inum_half, int eflag_either, int eflag_global, int eflag_atom, int vflag_atom, double* eng_vdwl, - typename ArrayTypes::t_efloat_1d eatom, int ntype, typename AT::t_int_1d_randomread type, typename AT::t_int_1d_randomread fmap, typename AT::t_x_array_randomread x, typename AT::t_int_1d_randomread numneigh, - typename AT::t_int_1d_randomread numneigh_full, typename AT::t_f_array f, typename ArrayTypes::t_virial_array vatom, typename AT::t_int_1d_randomread d_ilist_half, typename AT::t_int_1d_randomread d_offset, typename AT::t_neighbors_2d d_neighbors_half, typename AT::t_neighbors_2d d_neighbors_full, int neighflag) +MEAMKokkos::meam_force(int inum_half, int eflag_global, int eflag_atom, int vflag_global, int vflag_atom, + typename ArrayTypes::t_efloat_1d eatom, int ntype, typename AT::t_int_1d type, typename AT::t_int_1d d_map, typename AT::t_x_array x, typename AT::t_int_1d numneigh, + typename AT::t_int_1d numneigh_full, typename AT::t_f_array f, typename ArrayTypes::t_virial_array vatom, typename AT::t_int_1d d_ilist_half, typename AT::t_int_1d d_offset, typename AT::t_neighbors_2d d_neighbors_half, typename AT::t_neighbors_2d d_neighbors_full, int neighflag, int need_dup, EV_FLOAT &ev_all) { - EV_FLOAT ev; - ev.evdwl = *eng_vdwl; + EV_FLOAT ev; - this->eflag_either = eflag_either; - this->eflag_global = eflag_global; - this->eflag_atom = eflag_atom; - this->vflag_atom = vflag_atom; - this->d_eatom = eatom; - this->ntype = ntype; - this->type = type; - this->fmap = fmap; - this->x = x; - this->d_numneigh_half = numneigh; - this->d_numneigh_full = numneigh_full; - this->d_neighbors_half = d_neighbors_half; - this->d_neighbors_full = d_neighbors_full; - this->f = f; - this->d_vatom = vatom; - this->d_ilist_half = d_ilist_half; - this->d_offset = d_offset; - - if (neighflag == FULL) - Kokkos::parallel_reduce(Kokkos::RangePolicy>(0,inum_half),*this,ev); - else if (neighflag == HALF) - Kokkos::parallel_reduce(Kokkos::RangePolicy>(0,inum_half),*this,ev); - else if (neighflag == HALFTHREAD) - Kokkos::parallel_reduce(Kokkos::RangePolicy>(0,inum_half),*this,ev); - *eng_vdwl = ev.evdwl; + this->eflag_either = eflag_either; + this->eflag_global = eflag_global; + this->eflag_atom = eflag_atom; + this->vflag_global = vflag_global; + this->vflag_atom = vflag_atom; + eflag_either = eflag_atom || eflag_global; + vflag_either = vflag_atom || vflag_global; + this->d_eatom = eatom; + this->ntype = ntype; + this->type = type; + this->d_map = d_map; + this->x = x; + this->d_numneigh_half = numneigh; + this->d_numneigh_full = numneigh_full; + this->d_neighbors_half = d_neighbors_half; + this->d_neighbors_full = d_neighbors_full; + this->f = f; + this->d_vatom = vatom; + this->d_ilist_half = d_ilist_half; + this->d_offset = d_offset; + + if (need_dup) { + dup_f = Kokkos::Experimental::create_scatter_view(f); + if (eflag_atom) dup_eatom = Kokkos::Experimental::create_scatter_view(d_eatom); + if (vflag_atom) dup_vatom = Kokkos::Experimental::create_scatter_view(d_vatom); + } else { + ndup_f = Kokkos::Experimental::create_scatter_view(f); + if (eflag_atom) ndup_eatom = Kokkos::Experimental::create_scatter_view(d_eatom); + if (vflag_atom) ndup_vatom = Kokkos::Experimental::create_scatter_view(d_vatom); + } + + copymode = 1; + if (neighflag == HALF) + Kokkos::parallel_reduce(Kokkos::RangePolicy>(0,inum_half),*this,ev); + else if (neighflag == HALFTHREAD) + Kokkos::parallel_reduce(Kokkos::RangePolicy>(0,inum_half),*this,ev); + ev_all += ev; + copymode = 0; + + if (need_dup) { + Kokkos::Experimental::contribute(f, dup_f); + if (eflag_atom) Kokkos::Experimental::contribute(d_eatom, dup_eatom); + if (vflag_atom) Kokkos::Experimental::contribute(d_vatom, dup_vatom); + + // free duplicated memory + dup_f = decltype(dup_f)(); + if (eflag_atom) dup_eatom = decltype(dup_eatom)(); + if (vflag_atom) dup_vatom = decltype(dup_vatom)(); + } } template template KOKKOS_INLINE_FUNCTION void -MEAMKokkos::operator()(TagMEAMforce, const int &ii, EV_FLOAT& ev) const { +MEAMKokkos::operator()(TagMEAMForce, const int &ii, EV_FLOAT& ev) const { int i, j, jn, k, kn, kk, m, n, p, q; int nv2, nv3, elti, eltj, eltk, ind; X_FLOAT xitmp, yitmp, zitmp, delij[3]; - F_FLOAT rij2, rij, rij3; - F_FLOAT v[6], fi[3], fj[3]; - F_FLOAT third, sixth; - F_FLOAT pp, dUdrij, dUdsij, dUdrijm[3], force, forcem; - F_FLOAT r, recip, phi, phip; - F_FLOAT sij; - F_FLOAT a1, a1i, a1j, a2, a2i, a2j; - F_FLOAT a3i, a3j; - F_FLOAT shpi[3], shpj[3]; - F_FLOAT ai, aj, ro0i, ro0j, invrei, invrej; - F_FLOAT rhoa0j, drhoa0j, rhoa0i, drhoa0i; - F_FLOAT rhoa1j, drhoa1j, rhoa1i, drhoa1i; - F_FLOAT rhoa2j, drhoa2j, rhoa2i, drhoa2i; - F_FLOAT a3, a3a, rhoa3j, drhoa3j, rhoa3i, drhoa3i; - F_FLOAT drho0dr1, drho0dr2, drho0ds1, drho0ds2; - F_FLOAT drho1dr1, drho1dr2, drho1ds1, drho1ds2; - F_FLOAT drho1drm1[3], drho1drm2[3]; - F_FLOAT drho2dr1, drho2dr2, drho2ds1, drho2ds2; - F_FLOAT drho2drm1[3], drho2drm2[3]; - F_FLOAT drho3dr1, drho3dr2, drho3ds1, drho3ds2; - F_FLOAT drho3drm1[3], drho3drm2[3]; - F_FLOAT dt1dr1, dt1dr2, dt1ds1, dt1ds2; - F_FLOAT dt2dr1, dt2dr2, dt2ds1, dt2ds2; - F_FLOAT dt3dr1, dt3dr2, dt3ds1, dt3ds2; - F_FLOAT drhodr1, drhodr2, drhods1, drhods2, drhodrm1[3], drhodrm2[3]; - F_FLOAT arg; - F_FLOAT arg1i1, arg1j1, arg1i2, arg1j2, arg1i3, arg1j3, arg3i3, arg3j3; - F_FLOAT dsij1, dsij2, force1, force2; - F_FLOAT t1i, t2i, t3i, t1j, t2j, t3j; + double rij2, rij, rij3; + double v[6], fi[3], fj[3]; + double third, sixth; + double pp, dUdrij, dUdsij, dUdrijm[3], force, forcem; + double recip, phi, phip; + double sij; + double a1, a1i, a1j, a2, a2i, a2j; + double a3i, a3j; + double shpi[3], shpj[3]; + double ai, aj, ro0i, ro0j, invrei, invrej; + double rhoa0j, drhoa0j, rhoa0i, drhoa0i; + double rhoa1j, drhoa1j, rhoa1i, drhoa1i; + double rhoa2j, drhoa2j, rhoa2i, drhoa2i; + double a3, a3a, rhoa3j, drhoa3j, rhoa3i, drhoa3i; + double drho0dr1, drho0dr2, drho0ds1, drho0ds2; + double drho1dr1, drho1dr2, drho1ds1, drho1ds2; + double drho1drm1[3], drho1drm2[3]; + double drho2dr1, drho2dr2, drho2ds1, drho2ds2; + double drho2drm1[3], drho2drm2[3]; + double drho3dr1, drho3dr2, drho3ds1, drho3ds2; + double drho3drm1[3], drho3drm2[3]; + double dt1dr1, dt1dr2, dt1ds1, dt1ds2; + double dt2dr1, dt2dr2, dt2ds1, dt2ds2; + double dt3dr1, dt3dr2, dt3ds1, dt3ds2; + double drhodr1, drhodr2, drhods1, drhods2, drhodrm1[3], drhodrm2[3]; + double arg; + double arg1i1, arg1j1, arg1i2, arg1j2, arg1i3, arg1j3, arg3i3, arg3j3; + double dsij1, dsij2, force1, force2; + double t1i, t2i, t3i, t1j, t2j, t3j; int fnoffset; - // To do: update with duplication for OpenMP, atomic for GPUs - Kokkos::View::value> > a_eatom = d_eatom; - Kokkos::View::value> > a_vatom = d_vatom; - Kokkos::View::value> > a_f = f; + // The f, etc. arrays are duplicated for OpenMP, atomic for CUDA, and neither for Serial + auto v_f = ScatterViewHelper,decltype(dup_f),decltype(ndup_f)>::get(dup_f,ndup_f); + auto a_f = v_f.template access>(); + auto v_eatom = ScatterViewHelper,decltype(dup_eatom),decltype(ndup_eatom)>::get(dup_eatom,ndup_eatom); + auto a_eatom = v_eatom.template access>(); + auto v_vatom = ScatterViewHelper,decltype(dup_vatom),decltype(ndup_vatom)>::get(dup_vatom,ndup_vatom); + auto a_vatom = v_vatom.template access>(); i = d_ilist_half[ii]; fnoffset = d_offset[i]; third = 1.0 / 3.0; sixth = 1.0 / 6.0; - // Compute forces atom i - elti = fmap[type[i]]; + elti = d_map[type[i]]; if (elti < 0) return; xitmp = x(i,0); yitmp = x(i,1); zitmp = x(i,2); - // Treat each pair + // Treat each pair for (jn = 0; jn < d_numneigh_half[i]; jn++) { - //j = firstneigh[jn]; j = d_neighbors_half(i,jn); - eltj = fmap[type[j]]; + eltj = d_map[type[j]]; if (!iszero_kk(d_scrfcn[fnoffset + jn]) && eltj >= 0) { @@ -113,60 +136,60 @@ MEAMKokkos::operator()(TagMEAMforce, const int &ii, EV_FL delij[1] = x(j,1) - yitmp; delij[2] = x(j,2) - zitmp; rij2 = delij[0] * delij[0] + delij[1] * delij[1] + delij[2] * delij[2]; - if (rij2 < this->cutforcesq) { + if (rij2 < cutforcesq) { rij = sqrt(rij2); - r = rij; + recip = 1.0 / rij; - // Compute phi and phip - ind = this->eltind[elti][eltj]; - pp = rij * this->rdrar; + // Compute phi and phip + ind = eltind[elti][eltj]; + pp = rij * rdrar; kk = (int)pp; - kk = (kk <= (this->nrar - 2))?kk:this->nrar - 2; + kk = (kk <= (nrar - 2))?kk:nrar - 2; pp = pp - kk; pp = (pp <= 1.0)?pp:1.0; - phi = ((this->d_phirar3(ind,kk) * pp + this->d_phirar2(ind,kk)) * pp + this->d_phirar1(ind,kk)) * pp + - this->d_phirar(ind,kk); - phip = (this->d_phirar6(ind,kk) * pp + this->d_phirar5(ind,kk)) * pp + this->d_phirar4(ind,kk); - recip = 1.0 / r; + phi = ((d_phirar3(ind,kk) * pp + d_phirar2(ind,kk)) * pp + d_phirar1(ind,kk)) * pp + + d_phirar(ind,kk); + phip = (d_phirar6(ind,kk) * pp + d_phirar5(ind,kk)) * pp + d_phirar4(ind,kk); - if (eflag_either != 0) { - if (eflag_global != 0) - //*eng_vdwl = *eng_vdwl + phi * sij; - ev.evdwl = ev.evdwl + phi * sij; - if (eflag_atom != 0) { - a_eatom[i] += (0.5 * phi * sij); - a_eatom[j] += (0.5 * phi * sij); + if (eflag_either) { + double scaleij = d_scale(type[i],type[i]); + double phi_sc = phi * scaleij; + if (eflag_global) + ev.evdwl += phi_sc * sij; + if (eflag_atom) { + a_eatom[i] += 0.5 * phi * sij; + a_eatom[j] += 0.5 * phi * sij; } } - // write(1,*) "force_meamf: phi: ",phi - // write(1,*) "force_meamf: phip: ",phip + // write(1,*) "force_meamf: phi: ",phi + // write(1,*) "force_meamf: phip: ",phip - // Compute pair densities and derivatives - invrei = 1.0 / this->re_meam[elti][elti]; + // Compute pair densities and derivatives + invrei = 1.0 / re_meam[elti][elti]; ai = rij * invrei - 1.0; - ro0i = this->rho0_meam[elti]; - rhoa0i = ro0i * MathSpecialKokkos::fm_exp(-this->beta0_meam[elti] * ai); - drhoa0i = -this->beta0_meam[elti] * invrei * rhoa0i; - rhoa1i = ro0i * MathSpecialKokkos::fm_exp(-this->beta1_meam[elti] * ai); - drhoa1i = -this->beta1_meam[elti] * invrei * rhoa1i; - rhoa2i = ro0i * MathSpecialKokkos::fm_exp(-this->beta2_meam[elti] * ai); - drhoa2i = -this->beta2_meam[elti] * invrei * rhoa2i; - rhoa3i = ro0i * MathSpecialKokkos::fm_exp(-this->beta3_meam[elti] * ai); - drhoa3i = -this->beta3_meam[elti] * invrei * rhoa3i; + ro0i = rho0_meam[elti]; + rhoa0i = ro0i * MathSpecialKokkos::fm_exp(-beta0_meam[elti] * ai); + drhoa0i = -beta0_meam[elti] * invrei * rhoa0i; + rhoa1i = ro0i * MathSpecialKokkos::fm_exp(-beta1_meam[elti] * ai); + drhoa1i = -beta1_meam[elti] * invrei * rhoa1i; + rhoa2i = ro0i * MathSpecialKokkos::fm_exp(-beta2_meam[elti] * ai); + drhoa2i = -beta2_meam[elti] * invrei * rhoa2i; + rhoa3i = ro0i * MathSpecialKokkos::fm_exp(-beta3_meam[elti] * ai); + drhoa3i = -beta3_meam[elti] * invrei * rhoa3i; if (elti != eltj) { - invrej = 1.0 / this->re_meam[eltj][eltj]; + invrej = 1.0 / re_meam[eltj][eltj]; aj = rij * invrej - 1.0; - ro0j = this->rho0_meam[eltj]; - rhoa0j = ro0j * MathSpecialKokkos::fm_exp(-this->beta0_meam[eltj] * aj); - drhoa0j = -this->beta0_meam[eltj] * invrej * rhoa0j; - rhoa1j = ro0j * MathSpecialKokkos::fm_exp(-this->beta1_meam[eltj] * aj); - drhoa1j = -this->beta1_meam[eltj] * invrej * rhoa1j; - rhoa2j = ro0j * MathSpecialKokkos::fm_exp(-this->beta2_meam[eltj] * aj); - drhoa2j = -this->beta2_meam[eltj] * invrej * rhoa2j; - rhoa3j = ro0j * MathSpecialKokkos::fm_exp(-this->beta3_meam[eltj] * aj); - drhoa3j = -this->beta3_meam[eltj] * invrej * rhoa3j; + ro0j = rho0_meam[eltj]; + rhoa0j = ro0j * MathSpecialKokkos::fm_exp(-beta0_meam[eltj] * aj); + drhoa0j = -beta0_meam[eltj] * invrej * rhoa0j; + rhoa1j = ro0j * MathSpecialKokkos::fm_exp(-beta1_meam[eltj] * aj); + drhoa1j = -beta1_meam[eltj] * invrej * rhoa1j; + rhoa2j = ro0j * MathSpecialKokkos::fm_exp(-beta2_meam[eltj] * aj); + drhoa2j = -beta2_meam[eltj] * invrej * rhoa2j; + rhoa3j = ro0j * MathSpecialKokkos::fm_exp(-beta3_meam[eltj] * aj); + drhoa3j = -beta3_meam[eltj] * invrej * rhoa3j; } else { rhoa0j = rhoa0i; drhoa0j = drhoa0i; @@ -178,14 +201,14 @@ MEAMKokkos::operator()(TagMEAMforce, const int &ii, EV_FL drhoa3j = drhoa3i; } - const double t1mi = this->t1_meam[elti]; - const double t2mi = this->t2_meam[elti]; - const double t3mi = this->t3_meam[elti]; - const double t1mj = this->t1_meam[eltj]; - const double t2mj = this->t2_meam[eltj]; - const double t3mj = this->t3_meam[eltj]; + const double t1mi = t1_meam[elti]; + const double t2mi = t2_meam[elti]; + const double t3mi = t3_meam[elti]; + const double t1mj = t1_meam[eltj]; + const double t2mj = t2_meam[eltj]; + const double t3mj = t3_meam[eltj]; - if (this->ialloy == 1) { + if (ialloy == 1) { rhoa1j *= t1mj; rhoa2j *= t2mj; rhoa3j *= t3mj; @@ -213,12 +236,12 @@ MEAMKokkos::operator()(TagMEAMforce, const int &ii, EV_FL for (n = 0; n < 3; n++) { for (p = n; p < 3; p++) { for (q = p; q < 3; q++) { - arg = delij[n] * delij[p] * delij[q] * this->v3D[nv3]; + arg = delij[n] * delij[p] * delij[q] * v3D[nv3]; arg1i3 = arg1i3 + d_arho3(i,nv3) * arg; arg1j3 = arg1j3 - d_arho3(j,nv3) * arg; nv3 = nv3 + 1; } - arg = delij[n] * delij[p] * this->v2D[nv2]; + arg = delij[n] * delij[p] * v2D[nv2]; arg1i2 = arg1i2 + d_arho2(i,nv2) * arg; arg1j2 = arg1j2 + d_arho2(j,nv2) * arg; nv2 = nv2 + 1; @@ -229,11 +252,11 @@ MEAMKokkos::operator()(TagMEAMforce, const int &ii, EV_FL arg3j3 = arg3j3 - d_arho3b(j,n) * delij[n]; } - // rho0 terms + // rho0 terms drho0dr1 = drhoa0j * sij; drho0dr2 = drhoa0i * sij; - // rho1 terms + // rho1 terms a1 = 2 * sij / rij; drho1dr1 = a1 * (drhoa1j - rhoa1j / rij) * arg1i1; drho1dr2 = a1 * (drhoa1i - rhoa1i / rij) * arg1j1; @@ -243,7 +266,7 @@ MEAMKokkos::operator()(TagMEAMforce, const int &ii, EV_FL drho1drm2[m] = -a1 * rhoa1i * d_arho1(j,m); } - // rho2 terms + // rho2 terms a2 = 2 * sij / rij2; drho2dr1 = a2 * (drhoa2j - 2 * rhoa2j / rij) * arg1i2 - 2.0 / 3.0 * d_arho2b[i] * drhoa2j * sij; drho2dr2 = a2 * (drhoa2i - 2 * rhoa2i / rij) * arg1j2 - 2.0 / 3.0 * d_arho2b[j] * drhoa2i * sij; @@ -252,14 +275,14 @@ MEAMKokkos::operator()(TagMEAMforce, const int &ii, EV_FL drho2drm1[m] = 0.0; drho2drm2[m] = 0.0; for (n = 0; n < 3; n++) { - drho2drm1[m] = drho2drm1[m] + d_arho2(i,this->vind2D[m][n]) * delij[n]; - drho2drm2[m] = drho2drm2[m] - d_arho2(j,this->vind2D[m][n]) * delij[n]; + drho2drm1[m] = drho2drm1[m] + d_arho2(i,vind2D[m][n]) * delij[n]; + drho2drm2[m] = drho2drm2[m] - d_arho2(j,vind2D[m][n]) * delij[n]; } drho2drm1[m] = a2 * rhoa2j * drho2drm1[m]; drho2drm2[m] = -a2 * rhoa2i * drho2drm2[m]; } - // rho3 terms + // rho3 terms rij3 = rij * rij2; a3 = 2 * sij / rij3; a3a = 6.0 / 5.0 * sij / rij; @@ -273,9 +296,9 @@ MEAMKokkos::operator()(TagMEAMforce, const int &ii, EV_FL nv2 = 0; for (n = 0; n < 3; n++) { for (p = n; p < 3; p++) { - arg = delij[n] * delij[p] * this->v2D[nv2]; - drho3drm1[m] = drho3drm1[m] + d_arho3(i,this->vind3D[m][n][p]) * arg; - drho3drm2[m] = drho3drm2[m] + d_arho3(j,this->vind3D[m][n][p]) * arg; + arg = delij[n] * delij[p] * v2D[nv2]; + drho3drm1[m] = drho3drm1[m] + d_arho3(i,vind3D[m][n][p]) * arg; + drho3drm2[m] = drho3drm2[m] + d_arho3(j,vind3D[m][n][p]) * arg; nv2 = nv2 + 1; } } @@ -283,7 +306,7 @@ MEAMKokkos::operator()(TagMEAMforce, const int &ii, EV_FL drho3drm2[m] = (-a3 * drho3drm2[m] + a3a * d_arho3b(j,m)) * rhoa3i; } - // Compute derivatives of weighting functions t wrt rij + // Compute derivatives of weighting functions t wrt rij t1i = d_t_ave(i,0); t2i = d_t_ave(i,1); t3i = d_t_ave(i,2); @@ -291,7 +314,7 @@ MEAMKokkos::operator()(TagMEAMforce, const int &ii, EV_FL t2j = d_t_ave(j,1); t3j = d_t_ave(j,2); - if (this->ialloy == 1) { + if (ialloy == 1) { a1i = fdiv_zero_kk(drhoa0j * sij, d_tsq_ave(i,0)); a1j = fdiv_zero_kk(drhoa0i * sij, d_tsq_ave(j,0)); @@ -307,7 +330,7 @@ MEAMKokkos::operator()(TagMEAMforce, const int &ii, EV_FL dt3dr1 = a3i * (t3mj - t3i * MathSpecialKokkos::square(t3mj)); dt3dr2 = a3j * (t3mi - t3j * MathSpecialKokkos::square(t3mi)); - } else if (this->ialloy == 2) { + } else if (ialloy == 2) { dt1dr1 = 0.0; dt1dr2 = 0.0; @@ -333,25 +356,27 @@ MEAMKokkos::operator()(TagMEAMforce, const int &ii, EV_FL dt3dr2 = aj * (t3mi - t3j); } - // Compute derivatives of total density wrt rij, sij and rij(3) - get_shpfcn(this->lattce_meam[elti][elti], shpi); - get_shpfcn(this->lattce_meam[eltj][eltj], shpj); - drhodr1 = dgamma1[i] * drho0dr1 + - dgamma2[i] * (dt1dr1 * d_rho1[i] + t1i * drho1dr1 + dt2dr1 * d_rho2[i] + t2i * drho2dr1 + + // Compute derivatives of total density wrt rij, sij and rij(3) + get_shpfcn(lattce_meam[elti][elti], stheta_meam[elti][elti], ctheta_meam[elti][elti], shpi); + get_shpfcn(lattce_meam[eltj][eltj], stheta_meam[elti][elti], ctheta_meam[elti][elti], shpj); + + drhodr1 = d_dgamma1[i] * drho0dr1 + + d_dgamma2[i] * (dt1dr1 * d_rho1[i] + t1i * drho1dr1 + dt2dr1 * d_rho2[i] + t2i * drho2dr1 + dt3dr1 * d_rho3[i] + t3i * drho3dr1) - - dgamma3[i] * (shpi[0] * dt1dr1 + shpi[1] * dt2dr1 + shpi[2] * dt3dr1); - drhodr2 = dgamma1[j] * drho0dr2 + - dgamma2[j] * (dt1dr2 * d_rho1[j] + t1j * drho1dr2 + dt2dr2 * d_rho2[j] + t2j * drho2dr2 + + d_dgamma3[i] * (shpi[0] * dt1dr1 + shpi[1] * dt2dr1 + shpi[2] * dt3dr1); + drhodr2 = d_dgamma1[j] * drho0dr2 + + d_dgamma2[j] * (dt1dr2 * d_rho1[j] + t1j * drho1dr2 + dt2dr2 * d_rho2[j] + t2j * drho2dr2 + dt3dr2 * d_rho3[j] + t3j * drho3dr2) - - dgamma3[j] * (shpj[0] * dt1dr2 + shpj[1] * dt2dr2 + shpj[2] * dt3dr2); + d_dgamma3[j] * (shpj[0] * dt1dr2 + shpj[1] * dt2dr2 + shpj[2] * dt3dr2); for (m = 0; m < 3; m++) { drhodrm1[m] = 0.0; drhodrm2[m] = 0.0; - drhodrm1[m] = dgamma2[i] * (t1i * drho1drm1[m] + t2i * drho2drm1[m] + t3i * drho3drm1[m]); - drhodrm2[m] = dgamma2[j] * (t1j * drho1drm2[m] + t2j * drho2drm2[m] + t3j * drho3drm2[m]); + drhodrm1[m] = d_dgamma2[i] * (t1i * drho1drm1[m] + t2i * drho2drm1[m] + t3i * drho3drm1[m]); + drhodrm2[m] = d_dgamma2[j] * (t1j * drho1drm2[m] + t2j * drho2drm2[m] + t3j * drho3drm2[m]); + } - // Compute derivatives wrt sij, but only if necessary + // Compute derivatives wrt sij, but only if necessary if (!iszero_kk(d_dscrfcn[fnoffset + jn])) { drho0ds1 = rhoa0j; drho0ds2 = rhoa0i; @@ -366,7 +391,7 @@ MEAMKokkos::operator()(TagMEAMforce, const int &ii, EV_FL drho3ds1 = a3 * rhoa3j * arg1i3 - a3a * rhoa3j * arg3i3; drho3ds2 = a3 * rhoa3i * arg1j3 - a3a * rhoa3i * arg3j3; - if (this->ialloy == 1) { + if (ialloy == 1) { a1i = fdiv_zero_kk(rhoa0j, d_tsq_ave(i,0)); a1j = fdiv_zero_kk(rhoa0i, d_tsq_ave(j,0)); a2i = fdiv_zero_kk(rhoa0j, d_tsq_ave(i,1)); @@ -381,7 +406,7 @@ MEAMKokkos::operator()(TagMEAMforce, const int &ii, EV_FL dt3ds1 = a3i * (t3mj - t3i * MathSpecialKokkos::square(t3mj)); dt3ds2 = a3j * (t3mi - t3j * MathSpecialKokkos::square(t3mi)); - } else if (this->ialloy == 2) { + } else if (ialloy == 2) { dt1ds1 = 0.0; dt1ds2 = 0.0; @@ -417,7 +442,7 @@ MEAMKokkos::operator()(TagMEAMforce, const int &ii, EV_FL d_dgamma3[j] * (shpj[0] * dt1ds2 + shpj[1] * dt2ds2 + shpj[2] * dt3ds2); } - // Compute derivatives of energy wrt rij, sij and rij[3] + // Compute derivatives of energy wrt rij, sij and rij[3] dUdrij = phip * sij + d_frhop[i] * drhodr1 + d_frhop[j] * drhodr2; dUdsij = 0.0; if (!iszero_kk(d_dscrfcn[fnoffset + jn])) { @@ -427,17 +452,17 @@ MEAMKokkos::operator()(TagMEAMforce, const int &ii, EV_FL dUdrijm[m] = d_frhop[i] * drhodrm1[m] + d_frhop[j] * drhodrm2[m]; } - // Add the part of the force due to dUdrij and dUdsij + // Add the part of the force due to dUdrij and dUdsij force = dUdrij * recip + dUdsij * d_dscrfcn[fnoffset + jn]; for (m = 0; m < 3; m++) { forcem = delij[m] * force + dUdrijm[m]; a_f(i,m) += forcem; - a_f(j,m) -= -forcem; + a_f(j,m) -= forcem; } - // Tabulate per-atom virial as symmetrized stress tensor + // Tabulate per-atom virial as symmetrized stress tensor - if (vflag_atom != 0) { + if (vflag_either) { fi[0] = delij[0] * force + dUdrijm[0]; fi[1] = delij[1] * force + dUdrijm[1]; fi[2] = delij[2] * force + dUdrijm[2]; @@ -448,36 +473,41 @@ MEAMKokkos::operator()(TagMEAMforce, const int &ii, EV_FL v[4] = -0.25 * (delij[0] * fi[2] + delij[2] * fi[0]); v[5] = -0.25 * (delij[1] * fi[2] + delij[2] * fi[1]); - for (m = 0; m < 6; m++) { - a_vatom(i,m) += v[m]; - a_vatom(j,m) += v[m]; + if (vflag_global) + for (m = 0; m < 6; m++) + ev.v[m] += 2.0*v[m]; + + if (vflag_atom) { + for (m = 0; m < 6; m++) { + a_vatom(i,m) += v[m]; + a_vatom(j,m) += v[m]; + } } } - // Now compute forces on other atoms k due to change in sij + // Now compute forces on other atoms k due to change in sij - if (iszero_kk(sij) || iszero_kk(sij - 1.0)) continue; //: cont jn loop + if (iszero_kk(sij) || isone_kk(sij)) continue; //: cont jn loop double dxik(0), dyik(0), dzik(0); double dxjk(0), dyjk(0), dzjk(0); for (kn = 0; kn < d_numneigh_full[i]; kn++) { - //k = firstneigh_full[kn]; k = d_neighbors_full(i,kn); - eltk = fmap[type[k]]; + eltk = d_map[type[k]]; if (k != j && eltk >= 0) { double xik, xjk, cikj, sikj, dfc, a; double dCikj1, dCikj2; double delc, rik2, rjk2; sij = d_scrfcn[jn+fnoffset] * d_fcpair[jn+fnoffset]; - const double Cmax = this->Cmax_meam[elti][eltj][eltk]; - const double Cmin = this->Cmin_meam[elti][eltj][eltk]; + const double Cmax = Cmax_meam[elti][eltj][eltk]; + const double Cmin = Cmin_meam[elti][eltj][eltk]; dsij1 = 0.0; dsij2 = 0.0; - if (!iszero_kk(sij) && !iszero_kk(sij - 1.0)) { - const double rbound = rij2 * this->ebound_meam[elti][eltj]; + if (!iszero_kk(sij) && !isone_kk(sij)) { + const double rbound = rij2 * ebound_meam[elti][eltj]; delc = Cmax - Cmin; dxjk = x(k,0) - x(j,0); dyjk = x(k,1) - x(j,1); @@ -521,9 +551,9 @@ MEAMKokkos::operator()(TagMEAMforce, const int &ii, EV_FL a_f(k,1) -= force1 * dyik + force2 * dyjk; a_f(k,2) -= force1 * dzik + force2 * dzjk; - // Tabulate per-atom virial as symmetrized stress tensor + // Tabulate per-atom virial as symmetrized stress tensor - if (vflag_atom != 0) { + if (vflag_either) { fi[0] = force1 * dxik; fi[1] = force1 * dyik; fi[2] = force1 * dzik; @@ -537,18 +567,24 @@ MEAMKokkos::operator()(TagMEAMforce, const int &ii, EV_FL v[4] = -sixth * (dxik * fi[2] + dxjk * fj[2] + dzik * fi[0] + dzjk * fj[0]); v[5] = -sixth * (dyik * fi[2] + dyjk * fj[2] + dzik * fi[1] + dzjk * fj[1]); - for (m = 0; m < 6; m++) { - a_vatom(i,m) += v[m]; - a_vatom(j,m) += v[m]; - a_vatom(k,m) += v[m]; + if (vflag_global) + for (m = 0; m < 6; m++) + ev.v[m] += 3.0*v[m]; + + if (vflag_atom) { + for (m = 0; m < 6; m++) { + a_vatom(i,m) += v[m]; + a_vatom(j,m) += v[m]; + a_vatom(k,m) += v[m]; + } } } } } - // end of k loop + // end of k loop } } } - // end of j loop + // end of j loop } } diff --git a/src/KOKKOS/meam_funcs_kokkos.h b/src/KOKKOS/meam_funcs_kokkos.h index 9e41be9ea8..f02def0676 100644 --- a/src/KOKKOS/meam_funcs_kokkos.h +++ b/src/KOKKOS/meam_funcs_kokkos.h @@ -12,7 +12,7 @@ ------------------------------------------------------------------------- */ /* ---------------------------------------------------------------------- - Contributing author: Sebastian Hütter (OvGU) + Contributing author: Naga Vydyanathan (NVIDIA) ------------------------------------------------------------------------- */ #include "math_special_kokkos.h" @@ -22,12 +22,12 @@ using namespace MathSpecialKokkos; //----------------------------------------------------------------------------- // Compute G(gamma) based on selection flag ibar: -// 0 => G = sqrt(1+gamma) -// 1 => G = exp(gamma/2) -// 2 => not implemented -// 3 => G = 2/(1+exp(-gamma)) -// 4 => G = sqrt(1+gamma) -// -5 => G = +-sqrt(abs(1+gamma)) +// 0 => G = sqrt(1+gamma) +// 1 => G = exp(gamma/2) +// 2 => not implemented +// 3 => G = 2/(1+exp(-gamma)) +// 4 => G = sqrt(1+gamma) +// -5 => G = +-sqrt(abs(1+gamma)) // template KOKKOS_INLINE_FUNCTION @@ -40,9 +40,9 @@ double MEAMKokkos::G_gam(const double gamma, const int ibar, int &er case 4: gsmooth_switchpoint = -gsmooth_factor / (gsmooth_factor + 1); if (gamma < gsmooth_switchpoint) { - // e.g. gsmooth_factor is 99, {: - // gsmooth_switchpoint = -0.99 - // G = 0.01*(-0.99/gamma)**99 + // e.g. gsmooth_factor is 99, {: + // gsmooth_switchpoint = -0.99 + // G = 0.01*(-0.99/gamma)**99 double G = 1 / (gsmooth_factor + 1) * pow((gsmooth_switchpoint / gamma), gsmooth_factor); return sqrt(G); } else { @@ -51,7 +51,7 @@ double MEAMKokkos::G_gam(const double gamma, const int ibar, int &er case 1: return MathSpecialKokkos::fm_exp(gamma / 2.0); case 3: - return 2.0 / (1.0 + exp(-gamma)); + return 2.0 / (1.0 + MathSpecialKokkos::fm_exp(-gamma)); case -5: if ((1.0 + gamma) >= 0) { return sqrt(1.0 + gamma); @@ -65,12 +65,12 @@ double MEAMKokkos::G_gam(const double gamma, const int ibar, int &er //----------------------------------------------------------------------------- // Compute G(gamma and dG(gamma) based on selection flag ibar: -// 0 => G = sqrt(1+gamma) -// 1 => G = exp(gamma/2) -// 2 => not implemented -// 3 => G = 2/(1+exp(-gamma)) -// 4 => G = sqrt(1+gamma) -// -5 => G = +-sqrt(abs(1+gamma)) +// 0 => G = sqrt(1+gamma) +// 1 => G = exp(gamma/2) +// 2 => not implemented +// 3 => G = 2/(1+exp(-gamma)) +// 4 => G = sqrt(1+gamma) +// -5 => G = +-sqrt(abs(1+gamma)) // template KOKKOS_INLINE_FUNCTION @@ -84,9 +84,9 @@ double MEAMKokkos::dG_gam(const double gamma, const int ibar, double case 4: gsmooth_switchpoint = -gsmooth_factor / (gsmooth_factor + 1); if (gamma < gsmooth_switchpoint) { - // e.g. gsmooth_factor is 99, {: - // gsmooth_switchpoint = -0.99 - // G = 0.01*(-0.99/gamma)**99 + // e.g. gsmooth_factor is 99, {: + // gsmooth_switchpoint = -0.99 + // G = 0.01*(-0.99/gamma)**99 G = 1 / (gsmooth_factor + 1) * pow((gsmooth_switchpoint / gamma), gsmooth_factor); G = sqrt(G); dG = -gsmooth_factor * G / (2.0 * gamma); @@ -144,6 +144,30 @@ double MEAMKokkos::zbl(const double r, const int z1, const int z2) c return result; } +//----------------------------------------------------------------------------- +// Compute embedding function F(rhobar) and derivative F'(rhobar), eqn I.5 +// +template +KOKKOS_INLINE_FUNCTION +double MEAMKokkos::embedding(const double A, const double Ec, const double rhobar, double& dF) const +{ + const double AEc = A * Ec; + + if (rhobar > 0.0) { + const double lrb = log(rhobar); + dF = AEc * (1.0 + lrb); + return AEc * rhobar * lrb; + } else { + if (emb_lin_neg == 0) { + dF = 0.0; + return 0.0; + } else { + dF = - AEc; + return - AEc * rhobar; + } + } +} + //----------------------------------------------------------------------------- // Compute Rose energy function, I.16 // @@ -178,7 +202,7 @@ double MEAMKokkos::erose(const double r, const double re, const doub // template KOKKOS_INLINE_FUNCTION -void MEAMKokkos::get_shpfcn(const lattice_t latt, double (&s)[3]) const +void MEAMKokkos::get_shpfcn(const lattice_t latt, const double sthe, const double cthe, double (&s)[3]) const { switch (latt) { case FCC: @@ -194,7 +218,9 @@ void MEAMKokkos::get_shpfcn(const lattice_t latt, double (&s)[3]) co s[1] = 0.0; s[2] = 1.0 / 3.0; break; + case CH4: // CH4 actually needs shape factor for diamond for C, dimer for H case DIA: + case DIA3: s[0] = 0.0; s[1] = 0.0; s[2] = 32.0 / 9.0; @@ -202,12 +228,24 @@ void MEAMKokkos::get_shpfcn(const lattice_t latt, double (&s)[3]) co case DIM: s[0] = 1.0; s[1] = 2.0 / 3.0; - // s(3) = 1.d0 - s[2] = 0.40; + // s(4) = 1.d0 // this should be 0.4 unless (1-legendre) is multiplied in the density calc. + s[2] = 0.40; // this is (1-legendre) where legendre = 0.6 in dynamo is accounted. + break; + case LIN: // linear, theta being 180 + s[0] = 0.0; + s[1] = 8.0 / 3.0; // 4*(co**4 + si**4 - 1.0/3.0) in zig become 4*(1-1/3) + s[2] = 0.0; + break; + case ZIG: //zig-zag + case TRI: //trimer e.g. H2O + s[0] = 4.0*pow(cthe,2); + s[1] = 4.0*(pow(cthe,4) + pow(sthe,4) - 1.0/3.0); + s[2] = 4.0*(pow(cthe,2) * (3*pow(sthe,4) + pow(cthe,4))); + s[2] = s[2] - 0.6*s[0]; //legend in dyn, 0.6 is default value. break; default: s[0] = 0.0; - // call error('Lattice not defined in get_shpfcn.') + // call error('Lattice not defined in get_shpfcn.') } } @@ -225,102 +263,26 @@ int MEAMKokkos::get_Zij(const lattice_t latt) const return 8; case HCP: return 12; - case B1: - return 6; case DIA: + case DIA3: return 4; case DIM: return 1; + case B1: + return 6; case C11: return 10; case L12: return 12; case B2: return 8; - // call error('Lattice not defined in get_Zij.') + case CH4: // DYNAMO currently implemented this way while it needs two Z values, 4 and 1 + return 4; + case LIN: + case ZIG: + case TRI: + return 2; + // call error('Lattice not defined in get_Zij.') } return 0; } - -//----------------------------------------------------------------------------- -// Number of second neighbors for the reference structure -// a = distance ratio R1/R2 -// S = second neighbor screening function -// -template -KOKKOS_INLINE_FUNCTION -int MEAMKokkos::get_Zij2(const lattice_t latt, const double cmin, const double cmax, double& a, double& S) const -{ - - double C, x, sijk; - int Zij2 = 0, numscr = 0; - - switch (latt) { - - case FCC: - Zij2 = 6; - a = sqrt(2.0); - numscr = 4; - break; - - case BCC: - Zij2 = 6; - a = 2.0 / sqrt(3.0); - numscr = 4; - break; - - case HCP: - Zij2 = 6; - a = sqrt(2.0); - numscr = 4; - break; - - case B1: - Zij2 = 12; - a = sqrt(2.0); - numscr = 2; - break; - - case DIA: - Zij2 = 12; - a = sqrt(8.0 / 3.0); - numscr = 1; - if (cmin < 0.500001) { - // call error('can not do 2NN MEAM for dia') - } - break; - - case DIM: - // this really shouldn't be allowed; make sure screening is zero - a = 1.0; - S = 0.0; - return 0; - - case L12: - Zij2 = 6; - a = sqrt(2.0); - numscr = 4; - break; - - case B2: - Zij2 = 6; - a = 2.0 / sqrt(3.0); - numscr = 4; - break; - case C11: - // unsupported lattice flag C11 in get_Zij - break; - default: - // unknown lattic flag in get Zij - // call error('Lattice not defined in get_Zij.') - break; - } - - // Compute screening for each first neighbor - C = 4.0 / (a * a) - 1.0; - x = (C - cmin) / (cmax - cmin); - sijk = fcut(x); - // There are numscr first neighbors screening the second neighbors - S = MathSpecialKokkos::powint(sijk, numscr); - return Zij2; -} diff --git a/src/KOKKOS/meam_impl_kokkos.h b/src/KOKKOS/meam_impl_kokkos.h index 0d2ec99445..0a787ba2eb 100644 --- a/src/KOKKOS/meam_impl_kokkos.h +++ b/src/KOKKOS/meam_impl_kokkos.h @@ -12,11 +12,12 @@ ------------------------------------------------------------------------- */ /* ---------------------------------------------------------------------- - Contributing author: Sebastian Hütter (OvGU) + Contributing author: Naga Vydyanathan (NVIDIA), Stan Moore (SNL) ------------------------------------------------------------------------- */ #include "memory_kokkos.h" #include "meam_kokkos.h" + using namespace LAMMPS_NS; /* ---------------------------------------------------------------------- */ @@ -24,21 +25,15 @@ using namespace LAMMPS_NS; template MEAMKokkos::MEAMKokkos(Memory *mem) : MEAM(mem) { + d_errorflag = typename AT::t_int_scalar("meam:errorflag"); } template MEAMKokkos::~MEAMKokkos() { + if (copymode) return; + MemoryKokkos *memoryKK = (MemoryKokkos *)memory; - - memoryKK->destroy_kokkos(k_phirar6,phirar6); - memoryKK->destroy_kokkos(k_phirar5,phirar5); - memoryKK->destroy_kokkos(k_phirar4,phirar4); - memoryKK->destroy_kokkos(k_phirar3,phirar3); - memoryKK->destroy_kokkos(k_phirar2,phirar2); - memoryKK->destroy_kokkos(k_phirar1,phirar1); - memoryKK->destroy_kokkos(k_phirar,phirar); - memoryKK->destroy_kokkos(k_phir,phir); memoryKK->destroy_kokkos(k_rho,rho); memoryKK->destroy_kokkos(k_rho0,rho0); @@ -63,10 +58,10 @@ MEAMKokkos::~MEAMKokkos() memoryKK->destroy_kokkos(k_dscrfcn,dscrfcn); memoryKK->destroy_kokkos(k_fcpair,fcpair); } + #include "meam_setup_done_kokkos.h" #include "meam_funcs_kokkos.h" #include "meam_dens_init_kokkos.h" #include "meam_dens_final_kokkos.h" #include "meam_force_kokkos.h" -// diff --git a/src/KOKKOS/meam_kokkos.h b/src/KOKKOS/meam_kokkos.h index 0231f4b767..fb34f45b5c 100644 --- a/src/KOKKOS/meam_kokkos.h +++ b/src/KOKKOS/meam_kokkos.h @@ -14,68 +14,77 @@ namespace LAMMPS_NS { struct TagMEAMDensFinal{}; template struct TagMEAMDensInit{}; -struct TagMEAMInitialize{}; +struct TagMEAMZero{}; template -struct TagMEAMforce{}; +struct TagMEAMForce{}; template class MEAMKokkos : public MEAM { -public: + public: typedef ArrayTypes AT; typedef EV_FLOAT value_type; MEAMKokkos(Memory* mem); - ~MEAMKokkos(); + ~MEAMKokkos() override; KOKKOS_INLINE_FUNCTION void operator()(TagMEAMDensFinal, const int&, EV_FLOAT&) const; template KOKKOS_INLINE_FUNCTION - void operator()(TagMEAMDensInit, const int&, EV_FLOAT&) const; + void operator()(TagMEAMDensInit, const int&) const; KOKKOS_INLINE_FUNCTION - void operator()(TagMEAMInitialize, const int&) const; + void operator()(TagMEAMZero, const int&) const; template KOKKOS_INLINE_FUNCTION - void operator()(TagMEAMforce, const int&, EV_FLOAT&) const; -protected: -//Parameters to meam_dens_init - is there a better way to do this? - int ntype; - typename AT::t_int_1d_randomread type; - typename AT::t_int_1d_randomread d_offset; - typename AT::t_int_1d_randomread fmap; - typename AT::t_x_array_randomread x; - typename AT::t_int_1d_randomread d_numneigh_half; - typename AT::t_int_1d_randomread d_numneigh_full; + void operator()(TagMEAMForce, const int&, EV_FLOAT&) const; + private: + + // parameters to meam_dens_init + + int ntype, nlocal; + typename AT::t_int_1d type; + typename AT::t_int_1d d_offset; + typename AT::t_int_1d d_map; + typename AT::t_int_2d d_scale; + typename AT::t_x_array x; + typename AT::t_int_1d d_numneigh_half; + typename AT::t_int_1d d_numneigh_full; typename AT::t_neighbors_2d d_neighbors_half; typename AT::t_neighbors_2d d_neighbors_full; - typename AT::t_int_1d_randomread d_ilist_half; + typename AT::t_int_1d d_ilist_half; typename AT::t_f_array f; typename ArrayTypes::t_virial_array d_vatom; -//Parameters to meam_dens_final - is there a better way to do this? - int eflag_either, eflag_global, eflag_atom, vflag_atom; - double *eng_vdwl; + + // parameters to meam_dens_final + + typename AT::t_int_scalar d_errorflag; + int eflag_either, eflag_global, eflag_atom, vflag_either, vflag_global, vflag_atom; typename ArrayTypes::t_efloat_1d d_eatom; -public: - void meam_dens_setup(int, int, int); - void meam_setup_done(void); - void meam_dens_init(int , int , typename AT::t_int_1d_randomread , typename AT::t_int_1d_randomread, typename AT::t_x_array_randomread, typename AT::t_int_1d_randomread, - typename AT::t_int_1d_randomread , int* , typename AT::t_int_1d_randomread, typename AT::t_neighbors_2d,typename AT::t_neighbors_2d,typename AT::t_int_1d_randomread, int ); - void meam_dens_final(int , int , int , int , double* , - typename ArrayTypes::t_efloat_1d , int , typename AT::t_int_1d_randomread , typename AT::t_int_1d_randomread , int& ); - void meam_force(int , int , int , int , int , double* , - typename ArrayTypes::t_efloat_1d , int , typename AT::t_int_1d_randomread , typename AT::t_int_1d_randomread , typename AT::t_x_array_randomread , typename AT::t_int_1d_randomread , - typename AT::t_int_1d_randomread , typename AT::t_f_array , typename ArrayTypes::t_virial_array ,typename AT::t_int_1d_randomread , typename AT::t_int_1d_randomread, typename AT::t_neighbors_2d, typename AT::t_neighbors_2d, int); + public: + void meam_dens_setup(int, int, int) override; + void meam_setup_done(double*) override; + void meam_dens_init(int, int, typename AT::t_int_1d, typename AT::t_int_1d, typename AT::t_x_array, + typename AT::t_int_1d, typename AT::t_int_1d, typename AT::t_int_1d, + typename AT::t_neighbors_2d, typename AT::t_neighbors_2d, typename AT::t_int_1d, + int, int); + void meam_dens_final(int, int, int, int, typename ArrayTypes::t_efloat_1d, + int, typename AT::t_int_1d, typename AT::t_int_1d, typename AT::t_int_2d, int&, EV_FLOAT&); + void meam_force(int, int, int, int, int, typename ArrayTypes::t_efloat_1d, + int, typename AT::t_int_1d, typename AT::t_int_1d, typename AT::t_x_array, typename AT::t_int_1d, + typename AT::t_int_1d, typename AT::t_f_array, typename ArrayTypes::t_virial_array, + typename AT::t_int_1d, typename AT::t_int_1d, typename AT::t_neighbors_2d, typename AT::t_neighbors_2d, + int, int, EV_FLOAT&); template KOKKOS_INLINE_FUNCTION - void getscreen(int , int, typename AT::t_x_array_randomread , typename AT::t_int_1d_randomread, - typename AT::t_int_1d_randomread, int , typename AT::t_int_1d_randomread , typename AT::t_int_1d_randomread ) const; + void getscreen(int, int, typename AT::t_x_array, typename AT::t_int_1d, + typename AT::t_int_1d, int, typename AT::t_int_1d, typename AT::t_int_1d) const; template KOKKOS_INLINE_FUNCTION - void calc_rho1(int , int , typename AT::t_int_1d_randomread , typename AT::t_int_1d_randomread , typename AT::t_x_array_randomread , typename AT::t_int_1d_randomread, int ) const; + void calc_rho1(int, int, typename AT::t_int_1d, typename AT::t_int_1d, typename AT::t_x_array, typename AT::t_int_1d, int) const; KOKKOS_INLINE_FUNCTION double fcut(const double xi) const; KOKKOS_INLINE_FUNCTION @@ -89,18 +98,19 @@ public: KOKKOS_INLINE_FUNCTION double dG_gam(const double, const int, double&) const; KOKKOS_INLINE_FUNCTION - double zbl(const double, const int, const int) const; + double zbl(const double, const int, const int) const; + KOKKOS_INLINE_FUNCTION + double embedding(const double, const double, const double, double&) const; KOKKOS_INLINE_FUNCTION double erose(const double, const double, const double, const double, const double, const double, const int) const; KOKKOS_INLINE_FUNCTION - void get_shpfcn(const lattice_t latt, double (&s)[3]) const; + void get_shpfcn(const lattice_t latt, const double sthe, const double cthe, + double (&s)[3]) const; KOKKOS_INLINE_FUNCTION - int get_Zij(const lattice_t ) const; - KOKKOS_INLINE_FUNCTION - int get_Zij2(const lattice_t, const double, const double, double&, double&) const; -public: + int get_Zij(const lattice_t) const; + public: DAT::tdual_ffloat_1d k_rho, k_rho0, k_rho1, k_rho2, k_rho3, k_frhop; - typename ArrayTypes::t_ffloat_1d d_rho, d_rho0,d_rho1, d_rho2, d_rho3, d_frhop; + typename ArrayTypes::t_ffloat_1d d_rho, d_rho0, d_rho1, d_rho2, d_rho3, d_frhop; HAT::t_ffloat_1d h_rho, h_rho0, h_rho1, h_rho2, h_rho3, h_frhop; DAT::tdual_ffloat_1d k_gamma, k_dgamma1, k_dgamma2, k_dgamma3, k_arho2b; typename ArrayTypes::t_ffloat_1d d_gamma, d_dgamma1, d_dgamma2, d_dgamma3, d_arho2b; @@ -108,20 +118,54 @@ public: DAT::tdual_ffloat_2d k_arho1, k_arho2, k_arho3, k_arho3b, k_t_ave, k_tsq_ave; typename ArrayTypes::t_ffloat_2d d_arho1, d_arho2, d_arho3, d_arho3b, d_t_ave, d_tsq_ave; HAT::t_ffloat_2d h_arho1, h_arho2, h_arho3, h_arho3b, h_t_ave, h_tsq_ave; - DAT::tdual_ffloat_2d k_phir, k_phirar, k_phirar1, k_phirar2, k_phirar3, k_phirar4, k_phirar5, k_phirar6; typename ArrayTypes::t_ffloat_2d d_phir, d_phirar, d_phirar1, d_phirar2, d_phirar3, d_phirar4, d_phirar5, d_phirar6; - HAT::t_ffloat_2d h_phir, h_phirar, h_phirar1, h_phirar2, h_phirar3, h_phirar4, h_phirar5, h_phirar6; DAT::tdual_ffloat_1d k_scrfcn, k_dscrfcn, k_fcpair; typename ArrayTypes::t_ffloat_1d d_scrfcn, d_dscrfcn, d_fcpair; HAT::t_ffloat_1d h_scrfcn, h_dscrfcn, h_fcpair; - + protected: + int need_dup; + using KKDeviceType = typename KKDevice::value; + + template + using DupScatterView = KKScatterView; + + template + using NonDupScatterView = KKScatterView; + + DupScatterView dup_rho0; + NonDupScatterView ndup_rho0; + DupScatterView dup_arho2b; + NonDupScatterView ndup_arho2b; + DupScatterView dup_arho1; + NonDupScatterView ndup_arho1; + DupScatterView dup_arho2; + NonDupScatterView ndup_arho2; + DupScatterView dup_arho3; + NonDupScatterView ndup_arho3; + DupScatterView dup_arho3b; + NonDupScatterView ndup_arho3b; + DupScatterView dup_t_ave; + NonDupScatterView ndup_t_ave; + DupScatterView dup_tsq_ave; + NonDupScatterView ndup_tsq_ave; + DupScatterView dup_f; + NonDupScatterView ndup_f; + DupScatterView dup_eatom; + NonDupScatterView ndup_eatom; + DupScatterView dup_vatom; + NonDupScatterView ndup_vatom; }; + KOKKOS_INLINE_FUNCTION static bool iszero_kk(const double f) { return fabs(f) < 1e-20; } +KOKKOS_INLINE_FUNCTION +static bool isone_kk(const double f) { + return fabs(f-1.0) < 1e-20; +} KOKKOS_INLINE_FUNCTION static double fdiv_zero_kk(const double n, const double d) { @@ -134,9 +178,5 @@ static double fdiv_zero_kk(const double n, const double d) { } #include "meam_impl_kokkos.h" -//#include "meam_setup_done_kokkos.h" -//#include "meam_funcs_kokkos.h" -//#include "meam_dens_init_kokkos.h" -//#include "meam_dens_final_kokkos.h" -//#include "meam_force_kokkos.h" + #endif diff --git a/src/KOKKOS/meam_setup_done_kokkos.h b/src/KOKKOS/meam_setup_done_kokkos.h index 72852bf2cb..7d5de12427 100644 --- a/src/KOKKOS/meam_setup_done_kokkos.h +++ b/src/KOKKOS/meam_setup_done_kokkos.h @@ -1,71 +1,46 @@ #include "meam_kokkos.h" template -void MEAMKokkos::meam_setup_done(void) +void MEAMKokkos::meam_setup_done(double* cutmax) { - MemoryKokkos *memoryKK = (MemoryKokkos *)memory; + MEAM::meam_setup_done(cutmax); - memoryKK->destroy_kokkos(k_phirar6,phirar6); - memoryKK->destroy_kokkos(k_phirar5,phirar5); - memoryKK->destroy_kokkos(k_phirar4,phirar4); - memoryKK->destroy_kokkos(k_phirar3,phirar3); - memoryKK->destroy_kokkos(k_phirar2,phirar2); - memoryKK->destroy_kokkos(k_phirar1,phirar1); - memoryKK->destroy_kokkos(k_phirar,phirar); - memoryKK->destroy_kokkos(k_phir,phir); + MemKK::realloc_kokkos(d_phir, "pair:phir", (neltypes * (neltypes + 1)) / 2, nr); + MemKK::realloc_kokkos(d_phirar, "pair:phirar", (neltypes * (neltypes + 1)) / 2, nr); + MemKK::realloc_kokkos(d_phirar1, "pair:phirar1", (neltypes * (neltypes + 1)) / 2, nr); + MemKK::realloc_kokkos(d_phirar2, "pair:phirar2", (neltypes * (neltypes + 1)) / 2, nr); + MemKK::realloc_kokkos(d_phirar3, "pair:phirar3", (neltypes * (neltypes + 1)) / 2, nr); + MemKK::realloc_kokkos(d_phirar4, "pair:phirar4", (neltypes * (neltypes + 1)) / 2, nr); + MemKK::realloc_kokkos(d_phirar5, "pair:phirar5", (neltypes * (neltypes + 1)) / 2, nr); + MemKK::realloc_kokkos(d_phirar6, "pair:phirar6", (neltypes * (neltypes + 1)) / 2, nr); - memoryKK->create_kokkos(k_phir, phir, (neltypes * (neltypes + 1)) / 2, nr, "pair:phir"); - memoryKK->create_kokkos(k_phirar, phirar, (neltypes * (neltypes + 1)) / 2, nr, "pair:phirar"); - memoryKK->create_kokkos(k_phirar1, phirar1, (neltypes * (neltypes + 1)) / 2, nr, "pair:phirar1"); - memoryKK->create_kokkos(k_phirar2, phirar2, (neltypes * (neltypes + 1)) / 2, nr, "pair:phirar2"); - memoryKK->create_kokkos(k_phirar3, phirar3, (neltypes * (neltypes + 1)) / 2, nr, "pair:phirar3"); - memoryKK->create_kokkos(k_phirar4, phirar4, (neltypes * (neltypes + 1)) / 2, nr, "pair:phirar4"); - memoryKK->create_kokkos(k_phirar5, phirar5, (neltypes * (neltypes + 1)) / 2, nr, "pair:phirar5"); - memoryKK->create_kokkos(k_phirar6, phirar6, (neltypes * (neltypes + 1)) / 2, nr, "pair:phirar6"); - - h_phir = k_phir.h_view; - h_phirar = k_phirar.h_view; - h_phirar1 = k_phirar1.h_view; - h_phirar2 = k_phirar2.h_view; - h_phirar3 = k_phirar3.h_view; - h_phirar4 = k_phirar4.h_view; - h_phirar5 = k_phirar5.h_view; - h_phirar6 = k_phirar6.h_view; + auto h_phir = Kokkos::create_mirror_view(d_phir); + auto h_phirar = Kokkos::create_mirror_view(d_phirar); + auto h_phirar1 = Kokkos::create_mirror_view(d_phirar1); + auto h_phirar2 = Kokkos::create_mirror_view(d_phirar2); + auto h_phirar3 = Kokkos::create_mirror_view(d_phirar3); + auto h_phirar4 = Kokkos::create_mirror_view(d_phirar4); + auto h_phirar5 = Kokkos::create_mirror_view(d_phirar5); + auto h_phirar6 = Kokkos::create_mirror_view(d_phirar6); for (int i = 0; i <(neltypes * (neltypes + 1)) / 2; i++) - for(int j = 0; j < nr; j++) - { - h_phir(i,j) = phir[i][j]; - h_phirar(i,j) = phirar[i][j]; - h_phirar1(i,j) = phirar1[i][j]; - h_phirar2(i,j) = phirar2[i][j]; - h_phirar3(i,j) = phirar3[i][j]; - h_phirar4(i,j) = phirar4[i][j]; - h_phirar5(i,j) = phirar5[i][j]; - h_phirar6(i,j) = phirar6[i][j]; + for(int j = 0; j < nr; j++) { + h_phir(i,j) = phir[i][j]; + h_phirar(i,j) = phirar[i][j]; + h_phirar1(i,j) = phirar1[i][j]; + h_phirar2(i,j) = phirar2[i][j]; + h_phirar3(i,j) = phirar3[i][j]; + h_phirar4(i,j) = phirar4[i][j]; + h_phirar5(i,j) = phirar5[i][j]; + h_phirar6(i,j) = phirar6[i][j]; } - k_phir.template modify(); - k_phir.template sync(); - d_phir = k_phir.template view(); - k_phirar.template modify(); - k_phirar.template sync(); - d_phirar = k_phirar.template view(); - k_phirar1.template modify(); - k_phirar1.template sync(); - d_phirar1 = k_phirar1.template view(); - k_phirar2.template modify(); - k_phirar2.template sync(); - d_phirar2 = k_phirar2.template view(); - k_phirar3.template modify(); - k_phirar3.template sync(); - d_phirar3 = k_phirar3.template view(); - k_phirar4.template modify(); - k_phirar4.template sync(); - d_phirar4 = k_phirar4.template view(); - k_phirar5.template modify(); - k_phirar5.template sync(); - d_phirar5 = k_phirar5.template view(); - k_phirar6.template modify(); - k_phirar6.template sync(); - d_phirar6 = k_phirar6.template view(); + + Kokkos::deep_copy(d_phir,h_phir); + Kokkos::deep_copy(d_phirar,h_phirar); + Kokkos::deep_copy(d_phirar1,h_phirar1); + Kokkos::deep_copy(d_phirar2,h_phirar2); + Kokkos::deep_copy(d_phirar3,h_phirar3); + Kokkos::deep_copy(d_phirar4,h_phirar4); + Kokkos::deep_copy(d_phirar5,h_phirar5); + Kokkos::deep_copy(d_phirar6,h_phirar6); } diff --git a/src/KOKKOS/pair_meam_kokkos.cpp b/src/KOKKOS/pair_meam_kokkos.cpp index 38386d0a7a..33343f4af5 100644 --- a/src/KOKKOS/pair_meam_kokkos.cpp +++ b/src/KOKKOS/pair_meam_kokkos.cpp @@ -1,6 +1,6 @@ /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator - http://lammps.sandia.gov, Sandia National Laboratories + https://www.lammps.org/, Sandia National Laboratories Steve Plimpton, sjplimp@sandia.gov Copyright (2003) Sandia Corporation. Under the terms of Contract @@ -12,86 +12,67 @@ ------------------------------------------------------------------------- */ /* ---------------------------------------------------------------------- - Contributing author: Greg Wagner (SNL) + Contributing authors: Naga Vydyanathan (NVIDIA), Stan Moore (SNL) ------------------------------------------------------------------------- */ -#include -#include -#include -#include -//KK* -#include "meam_kokkos.h" -#include "kokkos.h" -#include "pair_kokkos.h" -//#include "pair_meamc.h" - #include "pair_meam_kokkos.h" +#include "meam_kokkos.h" + #include "atom_kokkos.h" -//*KK -#include "force.h" -#include "comm.h" -//KK* -//#include "memory.h" -#include "memory_kokkos.h" -//*KK -#include "neighbor.h" -//KK* -//#include "neigh_list.h" -#include "neigh_list_kokkos.h" -//*KK -#include "neigh_request.h" -#include "error.h" -//*KK #include "atom_masks.h" -//*KK +#include "comm.h" +#include "error.h" +#include "force.h" +#include "kokkos.h" +#include "memory_kokkos.h" +#include "neigh_list_kokkos.h" +#include "neigh_request.h" +#include "neighbor.h" + +#include using namespace LAMMPS_NS; -#if 0 -static const int nkeywords = 21; -static const char *keywords[] = { - "Ec","alpha","rho0","delta","lattce", - "attrac","repuls","nn2","Cmin","Cmax","rc","delr", - "augt1","gsmooth_factor","re","ialloy", - "mixture_ref_t","erose_form","zbl", - "emb_lin_neg","bkgd_dyn"}; -#endif - /* ---------------------------------------------------------------------- */ + template PairMEAMKokkos::PairMEAMKokkos(LAMMPS *lmp) : PairMEAM(lmp) { respa_enable = 0; + kokkosable = 1; + reverse_comm_device = 1; atomKK = (AtomKokkos *) atom; execution_space = ExecutionSpaceFromDevice::space; datamask_read = X_MASK | F_MASK | TYPE_MASK | ENERGY_MASK | VIRIAL_MASK; datamask_modify = F_MASK | ENERGY_MASK | VIRIAL_MASK; - meam_inst_kk = new MEAMKokkos(memory); + delete meam_inst; + meam_inst_kk = new MEAMKokkos(memory); meam_inst = meam_inst_kk; } + /* ---------------------------------------------------------------------- */ template PairMEAMKokkos::~PairMEAMKokkos() { - if (!copymode) { - memoryKK->destroy_kokkos(k_eatom,eatom); - memoryKK->destroy_kokkos(k_vatom,vatom); - delete meam_inst_kk; - } + if (copymode) return; + + memoryKK->destroy_kokkos(k_eatom,eatom); + memoryKK->destroy_kokkos(k_vatom,vatom); + delete meam_inst_kk; + meam_inst = nullptr; } /* ---------------------------------------------------------------------- */ -/* ---------------------------------------------------------------------- */ template void PairMEAMKokkos::compute(int eflag_in, int vflag_in) { eflag = eflag_in; vflag = vflag_in; - + if (neighflag == FULL) no_virial_fdotr_compute = 1; ev_init(eflag,vflag,0); @@ -105,36 +86,32 @@ void PairMEAMKokkos::compute(int eflag_in, int vflag_in) } if (vflag_atom) { memoryKK->destroy_kokkos(k_vatom,vatom); - memoryKK->create_kokkos(k_vatom,vatom,maxvatom,6,"pair:vatom"); + memoryKK->create_kokkos(k_vatom,vatom,maxvatom,"pair:vatom"); d_vatom = k_vatom.view(); } - atomKK->sync(execution_space,datamask_read); - if (eflag || vflag) atomKK->modified(execution_space,datamask_modify); - else atomKK->modified(execution_space,F_MASK); - - // neighbor list info - NeighListKokkos* k_halflist = static_cast*>(listhalf); int inum_half = listhalf->inum; - int* numneigh_half = listhalf->numneigh; - int* ilist_half = listhalf->ilist; - + NeighListKokkos* k_halflist = static_cast*>(listhalf); d_ilist_half = k_halflist->d_ilist; d_numneigh_half = k_halflist->d_numneigh; d_neighbors_half = k_halflist->d_neighbors; + NeighListKokkos* k_fulllist = static_cast*>(listfull); d_numneigh_full = k_fulllist->d_numneigh; d_neighbors_full = k_fulllist->d_neighbors; + EV_FLOAT ev; + copymode = 1; + meam_inst_kk->copymode = 1; // strip neighbor lists of any special bond flags before using with MEAM // necessary before doing neigh_f2c and neigh_c2f conversions each step - if (neighbor->ago == 0) { - Kokkos::parallel_for(Kokkos::RangePolicy(0,inum_half),*this); - } + + if (neighbor->ago == 0) + Kokkos::parallel_for(Kokkos::RangePolicy(0,inum_half),*this); // check size of scrfcn based on half neighbor list @@ -142,152 +119,137 @@ void PairMEAMKokkos::compute(int eflag_in, int vflag_in) nall = nlocal + atom->nghost; int n = 0; - //for (ii = 0; ii < inum_half; ii++) n += numneigh_half[ilist_half[ii]]; - Kokkos::parallel_reduce(Kokkos::RangePolicy(0,inum_half), *this, n); + Kokkos::parallel_reduce(Kokkos::RangePolicy(0,inum_half),*this,n); meam_inst_kk->meam_dens_setup(atom->nmax, nall, n); - //double **x = atom->x; x = atomKK->k_x.view(); - - //double **f = atom->f; f = atomKK->k_f.view(); - - //int *type = atom->type; type = atomKK->k_type.view(); + atomKK->sync(execution_space,datamask_read); + int ntype = atom->ntypes; // 3 stages of MEAM calculation // loop over my atoms followed by communication - int offset = 0; int errorflag = 0; -#if 0 - for (ii = 0; ii < inum_half; ii++) { - i = ilist_half[ii]; - meam_inst->meam_dens_init(i,ntype,type,map,x, - numneigh_half[i],firstneigh_half[i], - numneigh_full[i],firstneigh_full[i], - offset); - offset += numneigh_half[i]; - } -#endif - // To do: create the cumulative offset array in host and device - k_offset = DAT::tdual_int_1d("pair:offset",inum_half+1); - h_offset = k_offset.h_view; - d_offset = k_offset.template view(); - ArrayTypes::t_int_1d h_ilist; - ArrayTypes::t_int_1d h_numneigh; - h_ilist = Kokkos::create_mirror_view(k_halflist->d_ilist); - h_numneigh = Kokkos::create_mirror_view(k_halflist->d_numneigh); - Kokkos::deep_copy(h_ilist,k_halflist->d_ilist); - Kokkos::deep_copy(h_numneigh,k_halflist->d_numneigh); + d_offset = typename AT::t_int_1d("pair:offset",inum_half+1); + { + // local variables for lambda capture - h_offset[0] = 0; - for (int ii = 0; ii < inum_half; ii++) { - int i = h_ilist[ii]; - h_offset[ii+1] = h_offset[ii] + h_numneigh[i]; + auto l_ilist_half = d_ilist_half; + auto l_numneigh_half = d_numneigh_half; + auto l_offset = d_offset; + + Kokkos::parallel_scan(inum_half, LAMMPS_LAMBDA(int ii, int &m_fill, bool final) { + int i = l_ilist_half[ii]; + m_fill += l_numneigh_half[i]; + if (final) + l_offset[ii+1] = m_fill; + }); } - k_offset.template modify(); - k_offset.template sync(); - meam_inst_kk->meam_dens_init(inum_half,ntype,type,d_map,x,d_numneigh_half,d_numneigh_full,&offset,d_ilist_half,d_neighbors_half, d_neighbors_full, d_offset, neighflag); + + int need_dup = lmp->kokkos->need_dup(); + + meam_inst_kk->meam_dens_init(inum_half,ntype,type,d_map,x,d_numneigh_half,d_numneigh_full,d_ilist_half,d_neighbors_half, d_neighbors_full, d_offset, neighflag, need_dup); + meam_inst_kk->k_rho0.template modify(); - meam_inst_kk->k_rho0.template sync(); - meam_inst_kk->k_arho2b.template modify(); - meam_inst_kk->k_arho2b.template sync(); - meam_inst_kk->k_arho1.template modify(); - meam_inst_kk->k_arho1.template sync(); - meam_inst_kk->k_arho2.template modify(); - meam_inst_kk->k_arho2.template sync(); - meam_inst_kk->k_arho3.template modify(); - meam_inst_kk->k_arho3.template sync(); - meam_inst_kk->k_arho3b.template modify(); - meam_inst_kk->k_arho3b.template sync(); - meam_inst_kk->k_t_ave.template modify(); - meam_inst_kk->k_t_ave.template sync(); - meam_inst_kk->k_tsq_ave.template modify(); - meam_inst_kk->k_tsq_ave.template sync(); comm->reverse_comm(this); - meam_inst_kk->k_rho0.template modify(); meam_inst_kk->k_rho0.template sync(); - - meam_inst_kk->k_arho2b.template modify(); meam_inst_kk->k_arho2b.template sync(); - - meam_inst_kk->k_arho1.template modify(); meam_inst_kk->k_arho1.template sync(); - - meam_inst_kk->k_arho2.template modify(); meam_inst_kk->k_arho2.template sync(); - - meam_inst_kk->k_arho3.template modify(); meam_inst_kk->k_arho3.template sync(); - - meam_inst_kk->k_arho3b.template modify(); meam_inst_kk->k_arho3b.template sync(); - - meam_inst_kk->k_t_ave.template modify(); meam_inst_kk->k_t_ave.template sync(); - - meam_inst_kk->k_tsq_ave.template modify(); meam_inst_kk->k_tsq_ave.template sync(); - meam_inst_kk->meam_dens_final(nlocal,eflag_either,eflag_global,eflag_atom, - &eng_vdwl,d_eatom,ntype,type,d_map,errorflag); - if (errorflag) { - char str[128]; - sprintf(str,"MEAM library error %d",errorflag); - error->one(FLERR,str); - } + d_eatom,ntype,type,d_map,d_scale,errorflag,ev); + + if (errorflag) + error->one(FLERR,"MEAM library error {}",errorflag); + + meam_inst_kk->k_rho0.template modify(); + meam_inst_kk->k_rho1.template modify(); + meam_inst_kk->k_rho2.template modify(); + meam_inst_kk->k_rho3.template modify(); + meam_inst_kk->k_frhop.template modify(); + meam_inst_kk->k_gamma.template modify(); + meam_inst_kk->k_dgamma1.template modify(); + meam_inst_kk->k_dgamma2.template modify(); + meam_inst_kk->k_dgamma3.template modify(); + meam_inst_kk->k_arho2b.template modify(); + meam_inst_kk->k_arho1.template modify(); + meam_inst_kk->k_arho2.template modify(); + meam_inst_kk->k_arho3.template modify(); + meam_inst_kk->k_arho3b.template modify(); + meam_inst_kk->k_t_ave.template modify(); + meam_inst_kk->k_tsq_ave.template modify(); comm->forward_comm(this); - offset = 0; + meam_inst_kk->k_rho0.template sync(); + meam_inst_kk->k_rho1.template sync(); + meam_inst_kk->k_rho2.template sync(); + meam_inst_kk->k_rho3.template sync(); + meam_inst_kk->k_frhop.template sync(); + meam_inst_kk->k_gamma.template sync(); + meam_inst_kk->k_dgamma1.template sync(); + meam_inst_kk->k_dgamma2.template sync(); + meam_inst_kk->k_dgamma3.template sync(); + meam_inst_kk->k_arho2b.template sync(); + meam_inst_kk->k_arho1.template sync(); + meam_inst_kk->k_arho2.template sync(); + meam_inst_kk->k_arho3.template sync(); + meam_inst_kk->k_arho3b.template sync(); + meam_inst_kk->k_t_ave.template sync(); + meam_inst_kk->k_tsq_ave.template sync(); - // vptr is first value in vatom if it will be used by meam_force() - // else vatom may not exist, so pass dummy ptr + meam_inst_kk->meam_force(inum_half,eflag_global,eflag_atom,vflag_global, + vflag_atom,d_eatom,ntype,type,d_map,x, + d_numneigh_half, d_numneigh_full,f,d_vatom, + d_ilist_half, d_offset, d_neighbors_half, d_neighbors_full, + neighflag, need_dup, ev); -#if 0 // To do: is this correct? vflag_atom is used to access vatom - typename ArrayTypes::t_virial_array vptr; - if (vflag_atom) vptr = d_vatom; - else vptr = NULL; - for (ii = 0; ii < inum_half; ii++) { - i = ilist_half[ii]; - meam_inst->meam_force(i,eflag_either,eflag_global,eflag_atom, - vflag_atom,&eng_vdwl,eatom,ntype,type,map,x, - numneigh_half[i],firstneigh_half[i], - numneigh_full[i],firstneigh_full[i], - offset,f,vptr); - offset += numneigh_half[i]; + if (eflag_global) eng_vdwl += ev.evdwl; + if (vflag_global) { + virial[0] += ev.v[0]; + virial[1] += ev.v[1]; + virial[2] += ev.v[2]; + virial[3] += ev.v[3]; + virial[4] += ev.v[4]; + virial[5] += ev.v[5]; } -#endif - meam_inst_kk->meam_force(inum_half, eflag_either,eflag_global,eflag_atom, - vflag_atom,&eng_vdwl,d_eatom,ntype,type,d_map,x, - d_numneigh_half, d_numneigh_full,f,d_vatom,d_ilist_half, d_offset, d_neighbors_half, d_neighbors_full, neighflag); if (vflag_fdotr) pair_virial_fdotr_compute(this); if (eflag_atom) { k_eatom.template modify(); - k_eatom.template sync(); + k_eatom.sync_host(); } if (vflag_atom) { k_vatom.template modify(); - k_vatom.template sync(); + k_vatom.sync_host(); } + if (eflag || vflag) atomKK->modified(execution_space,datamask_modify); + else atomKK->modified(execution_space,F_MASK); + + copymode = 0; + meam_inst_kk->copymode = 0; } /* ---------------------------------------------------------------------- @@ -298,24 +260,22 @@ void PairMEAMKokkos::coeff(int narg, char **arg) { PairMEAM::coeff(narg,arg); - //sync map + // sync map and scale int n = atom->ntypes; - k_map = DAT::tdual_int_1d("pair:map",n+1); - HAT::t_int_1d h_map = k_map.h_view; + MemKK::realloc_kokkos(d_map,"pair:map",n+1); + MemKK::realloc_kokkos(d_scale,"pair:scale",n+1,n+1); + auto h_map = Kokkos::create_mirror_view(d_map); + auto h_scale = Kokkos::create_mirror_view(d_scale); - for (int i = 1; i <= n; i++) + for (int i = 1; i <= n; i++) { h_map[i] = map[i]; + for (int j = 1; j <= n; j++) + h_scale(i,j) = scale[i][j]; + } - k_map.template modify(); - k_map.template sync(); - - d_map = k_map.template view(); - - // To do: need to synchronize phirar variables - - meam_inst_kk->meam_setup_done(); - + Kokkos::deep_copy(d_map,h_map); + Kokkos::deep_copy(d_scale,h_scale); } /* ---------------------------------------------------------------------- @@ -324,24 +284,27 @@ void PairMEAMKokkos::coeff(int narg, char **arg) template void PairMEAMKokkos::init_style() { - PairMEAM::init_style(); + // adjust neighbor list request for KOKKOS + neighflag = lmp->kokkos->neighflag; - auto request = neighbor->find_request(this); - - // MEAM needs both a full and half neighbor list? Not sure how to get that. - if (!(neighflag == FULL || neighflag == HALF || neighflag == HALFTHREAD)) - error->all(FLERR, "Cannot use chosen neighbor list style with pair meam/kk"); - + auto request = neighbor->find_request(this,1); request->set_kokkos_host(std::is_same::value && !std::is_same::value); request->set_kokkos_device(std::is_same::value); - if (neighflag == FULL) request->enable_full(); + request = neighbor->find_request(this,2); + request->set_kokkos_host(std::is_same::value && + !std::is_same::value); + request->set_kokkos_device(std::is_same::value); + + if (neighflag == FULL) + error->all(FLERR,"Must use half neighbor list style with pair meam/kk"); } /* ---------------------------------------------------------------------- */ + template int PairMEAMKokkos::pack_forward_comm_kokkos(int n, DAT::tdual_int_2d k_sendlist, int iswap_in, DAT::tdual_xfloat_1d &buf, int pbc_flag, int *pbc) @@ -350,9 +313,11 @@ int PairMEAMKokkos::pack_forward_comm_kokkos(int n, DAT::tdual_int_2 iswap = iswap_in; v_buf = buf.view(); Kokkos::parallel_for(Kokkos::RangePolicy(0,n),*this); - return n; + return n*38; } +/* ---------------------------------------------------------------------- */ + template KOKKOS_INLINE_FUNCTION void PairMEAMKokkos::operator()(TagPairMEAMPackForwardComm, const int &i) const { @@ -361,35 +326,36 @@ void PairMEAMKokkos::operator()(TagPairMEAMPackForwardComm, const in v_buf[m++] = meam_inst_kk->d_rho0[j]; v_buf[m++] = meam_inst_kk->d_rho1[j]; v_buf[m++] = meam_inst_kk->d_rho2[j]; - v_buf[m++] = meam_inst_kk->d_rho3[j]; - v_buf[m++] = meam_inst_kk->d_frhop[j]; - v_buf[m++] = meam_inst_kk->d_gamma[j]; - v_buf[m++] = meam_inst_kk->d_dgamma1[j]; - v_buf[m++] = meam_inst_kk->d_dgamma2[j]; - v_buf[m++] = meam_inst_kk->d_dgamma3[j]; - v_buf[m++] = meam_inst_kk->d_arho2b[j]; - v_buf[m++] = meam_inst_kk->d_arho1(j,0); - v_buf[m++] = meam_inst_kk->d_arho1(j,1); - v_buf[m++] = meam_inst_kk->d_arho1(j,2); - v_buf[m++] = meam_inst_kk->d_arho2(j,0); - v_buf[m++] = meam_inst_kk->d_arho2(j,1); - v_buf[m++] = meam_inst_kk->d_arho2(j,2); - v_buf[m++] = meam_inst_kk->d_arho2(j,3); - v_buf[m++] = meam_inst_kk->d_arho2(j,4); - v_buf[m++] = meam_inst_kk->d_arho2(j,5); - for (int k = 0; k < 10; k++) v_buf[m++] = meam_inst_kk->d_arho3(j,k); - v_buf[m++] = meam_inst_kk->d_arho3b(j,0); - v_buf[m++] = meam_inst_kk->d_arho3b(j,1); - v_buf[m++] = meam_inst_kk->d_arho3b(j,2); - v_buf[m++] = meam_inst_kk->d_t_ave(j,0); - v_buf[m++] = meam_inst_kk->d_t_ave(j,1); - v_buf[m++] = meam_inst_kk->d_t_ave(j,2); - v_buf[m++] = meam_inst_kk->d_tsq_ave(j,0); - v_buf[m++] = meam_inst_kk->d_tsq_ave(j,1); - v_buf[m++] = meam_inst_kk->d_tsq_ave(j,2); + v_buf[m++] = meam_inst_kk->d_rho3[j]; + v_buf[m++] = meam_inst_kk->d_frhop[j]; + v_buf[m++] = meam_inst_kk->d_gamma[j]; + v_buf[m++] = meam_inst_kk->d_dgamma1[j]; + v_buf[m++] = meam_inst_kk->d_dgamma2[j]; + v_buf[m++] = meam_inst_kk->d_dgamma3[j]; + v_buf[m++] = meam_inst_kk->d_arho2b[j]; + v_buf[m++] = meam_inst_kk->d_arho1(j,0); + v_buf[m++] = meam_inst_kk->d_arho1(j,1); + v_buf[m++] = meam_inst_kk->d_arho1(j,2); + v_buf[m++] = meam_inst_kk->d_arho2(j,0); + v_buf[m++] = meam_inst_kk->d_arho2(j,1); + v_buf[m++] = meam_inst_kk->d_arho2(j,2); + v_buf[m++] = meam_inst_kk->d_arho2(j,3); + v_buf[m++] = meam_inst_kk->d_arho2(j,4); + v_buf[m++] = meam_inst_kk->d_arho2(j,5); + for (int k = 0; k < 10; k++) v_buf[m++] = meam_inst_kk->d_arho3(j,k); + v_buf[m++] = meam_inst_kk->d_arho3b(j,0); + v_buf[m++] = meam_inst_kk->d_arho3b(j,1); + v_buf[m++] = meam_inst_kk->d_arho3b(j,2); + v_buf[m++] = meam_inst_kk->d_t_ave(j,0); + v_buf[m++] = meam_inst_kk->d_t_ave(j,1); + v_buf[m++] = meam_inst_kk->d_t_ave(j,2); + v_buf[m++] = meam_inst_kk->d_tsq_ave(j,0); + v_buf[m++] = meam_inst_kk->d_tsq_ave(j,1); + v_buf[m++] = meam_inst_kk->d_tsq_ave(j,2); } /* ---------------------------------------------------------------------- */ + template void PairMEAMKokkos::unpack_forward_comm_kokkos(int n, int first_in, DAT::tdual_xfloat_1d &buf) { @@ -398,6 +364,8 @@ void PairMEAMKokkos::unpack_forward_comm_kokkos(int n, int first_in, Kokkos::parallel_for(Kokkos::RangePolicy(0,n),*this); } +/* ---------------------------------------------------------------------- */ + template KOKKOS_INLINE_FUNCTION void PairMEAMKokkos::operator()(TagPairMEAMUnpackForwardComm, const int &i) const{ @@ -432,18 +400,34 @@ void PairMEAMKokkos::operator()(TagPairMEAMUnpackForwardComm, const meam_inst_kk->d_tsq_ave(i+first,0) = v_buf[m++]; meam_inst_kk->d_tsq_ave(i+first,1) = v_buf[m++]; meam_inst_kk->d_tsq_ave(i+first,2) = v_buf[m++]; - } + } + +/* ---------------------------------------------------------------------- */ template int PairMEAMKokkos::pack_forward_comm(int n, int *list, double *buf, int pbc_flag, int *pbc) { - int i,j,k,m; + meam_inst_kk->k_rho0.sync_host(); + meam_inst_kk->k_rho1.sync_host(); + meam_inst_kk->k_rho2.sync_host(); + meam_inst_kk->k_rho3.sync_host(); + meam_inst_kk->k_frhop.sync_host(); + meam_inst_kk->k_gamma.sync_host(); + meam_inst_kk->k_dgamma1.sync_host(); + meam_inst_kk->k_dgamma2.sync_host(); + meam_inst_kk->k_dgamma3.sync_host(); + meam_inst_kk->k_arho2b.sync_host(); + meam_inst_kk->k_arho1.sync_host(); + meam_inst_kk->k_arho2.sync_host(); + meam_inst_kk->k_arho3.sync_host(); + meam_inst_kk->k_arho3b.sync_host(); + meam_inst_kk->k_t_ave.sync_host(); + meam_inst_kk->k_tsq_ave.sync_host(); - m = 0; - - for (i = 0; i < n; i++) { - j = list[i]; + int m = 0; + for (int i = 0; i < n; i++) { + const int j = list[i]; buf[m++] = meam_inst_kk->h_rho0[j]; buf[m++] = meam_inst_kk->h_rho1[j]; buf[m++] = meam_inst_kk->h_rho2[j]; @@ -463,7 +447,7 @@ int PairMEAMKokkos::pack_forward_comm(int n, int *list, double *buf, buf[m++] = meam_inst_kk->h_arho2(j,3); buf[m++] = meam_inst_kk->h_arho2(j,4); buf[m++] = meam_inst_kk->h_arho2(j,5); - for (k = 0; k < 10; k++) buf[m++] = meam_inst_kk->h_arho3(j,k); + for (int k = 0; k < 10; k++) buf[m++] = meam_inst_kk->h_arho3(j,k); buf[m++] = meam_inst_kk->h_arho3b(j,0); buf[m++] = meam_inst_kk->h_arho3b(j,1); buf[m++] = meam_inst_kk->h_arho3b(j,2); @@ -478,14 +462,31 @@ int PairMEAMKokkos::pack_forward_comm(int n, int *list, double *buf, return m; } +/* ---------------------------------------------------------------------- */ + template void PairMEAMKokkos::unpack_forward_comm(int n, int first, double *buf) { - int i,k,m,last; + meam_inst_kk->k_rho0.sync_host(); + meam_inst_kk->k_rho1.sync_host(); + meam_inst_kk->k_rho2.sync_host(); + meam_inst_kk->k_rho3.sync_host(); + meam_inst_kk->k_frhop.sync_host(); + meam_inst_kk->k_gamma.sync_host(); + meam_inst_kk->k_dgamma1.sync_host(); + meam_inst_kk->k_dgamma2.sync_host(); + meam_inst_kk->k_dgamma3.sync_host(); + meam_inst_kk->k_arho2b.sync_host(); + meam_inst_kk->k_arho1.sync_host(); + meam_inst_kk->k_arho2.sync_host(); + meam_inst_kk->k_arho3.sync_host(); + meam_inst_kk->k_arho3b.sync_host(); + meam_inst_kk->k_t_ave.sync_host(); + meam_inst_kk->k_tsq_ave.sync_host(); - m = 0; - last = first + n; - for (i = first; i < last; i++) { + int m = 0; + const int last = first + n; + for (int i = first; i < last; i++) { meam_inst_kk->h_rho0[i] = buf[m++]; meam_inst_kk->h_rho1[i] = buf[m++]; meam_inst_kk->h_rho2[i] = buf[m++]; @@ -505,7 +506,7 @@ void PairMEAMKokkos::unpack_forward_comm(int n, int first, double *b meam_inst_kk->h_arho2(i,3) = buf[m++]; meam_inst_kk->h_arho2(i,4) = buf[m++]; meam_inst_kk->h_arho2(i,5) = buf[m++]; - for (k = 0; k < 10; k++) meam_inst_kk->h_arho3(i,k) = buf[m++]; + for (int k = 0; k < 10; k++) meam_inst_kk->h_arho3(i,k) = buf[m++]; meam_inst_kk->h_arho3b(i,0) = buf[m++]; meam_inst_kk->h_arho3b(i,1) = buf[m++]; meam_inst_kk->h_arho3b(i,2) = buf[m++]; @@ -516,17 +517,83 @@ void PairMEAMKokkos::unpack_forward_comm(int n, int first, double *b meam_inst_kk->h_tsq_ave(i,1) = buf[m++]; meam_inst_kk->h_tsq_ave(i,2) = buf[m++]; } + + meam_inst_kk->k_rho0.modify_host(); + meam_inst_kk->k_rho1.modify_host(); + meam_inst_kk->k_rho2.modify_host(); + meam_inst_kk->k_rho3.modify_host(); + meam_inst_kk->k_frhop.modify_host(); + meam_inst_kk->k_gamma.modify_host(); + meam_inst_kk->k_dgamma1.modify_host(); + meam_inst_kk->k_dgamma2.modify_host(); + meam_inst_kk->k_dgamma3.modify_host(); + meam_inst_kk->k_arho2b.modify_host(); + meam_inst_kk->k_arho1.modify_host(); + meam_inst_kk->k_arho2.modify_host(); + meam_inst_kk->k_arho3.modify_host(); + meam_inst_kk->k_arho3b.modify_host(); + meam_inst_kk->k_t_ave.modify_host(); + meam_inst_kk->k_tsq_ave.modify_host(); } /* ---------------------------------------------------------------------- */ + +template +int PairMEAMKokkos::pack_reverse_comm_kokkos(int n, int first_in, DAT::tdual_xfloat_1d &buf) +{ + first = first_in; + v_buf = buf.view(); + Kokkos::parallel_for(Kokkos::RangePolicy(0,n),*this); + return n*30; +} + +/* ---------------------------------------------------------------------- */ + +template +KOKKOS_INLINE_FUNCTION +void PairMEAMKokkos::operator()(TagPairMEAMPackReverseComm, const int &i) const { + int m = i*30; + + v_buf[m++] = meam_inst_kk->d_rho0[i+first]; + v_buf[m++] = meam_inst_kk->d_arho2b[i+first]; + v_buf[m++] = meam_inst_kk->d_arho1(i+first,0); + v_buf[m++] = meam_inst_kk->d_arho1(i+first,1); + v_buf[m++] = meam_inst_kk->d_arho1(i+first,2); + v_buf[m++] = meam_inst_kk->d_arho2(i+first,0); + v_buf[m++] = meam_inst_kk->d_arho2(i+first,1); + v_buf[m++] = meam_inst_kk->d_arho2(i+first,2); + v_buf[m++] = meam_inst_kk->d_arho2(i+first,3); + v_buf[m++] = meam_inst_kk->d_arho2(i+first,4); + v_buf[m++] = meam_inst_kk->d_arho2(i+first,5); + for (int k = 0; k < 10; k++) v_buf[m++] = meam_inst_kk->d_arho3(i+first,k); + v_buf[m++] = meam_inst_kk->d_arho3b(i+first,0); + v_buf[m++] = meam_inst_kk->d_arho3b(i+first,1); + v_buf[m++] = meam_inst_kk->d_arho3b(i+first,2); + v_buf[m++] = meam_inst_kk->d_t_ave(i+first,0); + v_buf[m++] = meam_inst_kk->d_t_ave(i+first,1); + v_buf[m++] = meam_inst_kk->d_t_ave(i+first,2); + v_buf[m++] = meam_inst_kk->d_tsq_ave(i+first,0); + v_buf[m++] = meam_inst_kk->d_tsq_ave(i+first,1); + v_buf[m++] = meam_inst_kk->d_tsq_ave(i+first,2); +} + +/* ---------------------------------------------------------------------- */ + template int PairMEAMKokkos::pack_reverse_comm(int n, int first, double *buf) { - int i,k,m,last; + meam_inst_kk->k_rho0.sync_host(); + meam_inst_kk->k_arho2b.sync_host(); + meam_inst_kk->k_arho1.sync_host(); + meam_inst_kk->k_arho2.sync_host(); + meam_inst_kk->k_arho3.sync_host(); + meam_inst_kk->k_arho3b.sync_host(); + meam_inst_kk->k_t_ave.sync_host(); + meam_inst_kk->k_tsq_ave.sync_host(); - m = 0; - last = first + n; - for (i = first; i < last; i++) { + int m = 0; + const int last = first + n; + for (int i = first; i < last; i++) { buf[m++] = meam_inst_kk->h_rho0[i]; buf[m++] = meam_inst_kk->h_arho2b[i]; buf[m++] = meam_inst_kk->h_arho1(i,0); @@ -538,7 +605,7 @@ int PairMEAMKokkos::pack_reverse_comm(int n, int first, double *buf) buf[m++] = meam_inst_kk->h_arho2(i,3); buf[m++] = meam_inst_kk->h_arho2(i,4); buf[m++] = meam_inst_kk->h_arho2(i,5); - for (k = 0; k < 10; k++) buf[m++] = meam_inst_kk->h_arho3(i,k); + for (int k = 0; k < 10; k++) buf[m++] = meam_inst_kk->h_arho3(i,k); buf[m++] = meam_inst_kk->h_arho3b(i,0); buf[m++] = meam_inst_kk->h_arho3b(i,1); buf[m++] = meam_inst_kk->h_arho3b(i,2); @@ -554,14 +621,64 @@ int PairMEAMKokkos::pack_reverse_comm(int n, int first, double *buf) } /* ---------------------------------------------------------------------- */ + +template +void PairMEAMKokkos::unpack_reverse_comm_kokkos(int n, DAT::tdual_int_2d k_sendlist, int iswap_in, DAT::tdual_xfloat_1d &buf) +{ + d_sendlist = k_sendlist.view(); + iswap = iswap_in; + v_buf = buf.view(); + Kokkos::parallel_for(Kokkos::RangePolicy(0,n),*this); +} + +/* ---------------------------------------------------------------------- */ + +template +KOKKOS_INLINE_FUNCTION +void PairMEAMKokkos::operator()(TagPairMEAMUnpackReverseComm, const int &i) const { + int j = d_sendlist(iswap, i); + int m = i*30; + + meam_inst_kk->d_rho0[j] += v_buf[m++]; + meam_inst_kk->d_arho2b[j] += v_buf[m++]; + meam_inst_kk->d_arho1(j,0) += v_buf[m++]; + meam_inst_kk->d_arho1(j,1) += v_buf[m++]; + meam_inst_kk->d_arho1(j,2) += v_buf[m++]; + meam_inst_kk->d_arho2(j,0) += v_buf[m++]; + meam_inst_kk->d_arho2(j,1) += v_buf[m++]; + meam_inst_kk->d_arho2(j,2) += v_buf[m++]; + meam_inst_kk->d_arho2(j,3) += v_buf[m++]; + meam_inst_kk->d_arho2(j,4) += v_buf[m++]; + meam_inst_kk->d_arho2(j,5) += v_buf[m++]; + for (int k = 0; k < 10; k++) meam_inst_kk->d_arho3(j,k) += v_buf[m++]; + meam_inst_kk->d_arho3b(j,0) += v_buf[m++]; + meam_inst_kk->d_arho3b(j,1) += v_buf[m++]; + meam_inst_kk->d_arho3b(j,2) += v_buf[m++]; + meam_inst_kk->d_t_ave(j,0) += v_buf[m++]; + meam_inst_kk->d_t_ave(j,1) += v_buf[m++]; + meam_inst_kk->d_t_ave(j,2) += v_buf[m++]; + meam_inst_kk->d_tsq_ave(j,0) += v_buf[m++]; + meam_inst_kk->d_tsq_ave(j,1) += v_buf[m++]; + meam_inst_kk->d_tsq_ave(j,2) += v_buf[m++]; +} + +/* ---------------------------------------------------------------------- */ + template void PairMEAMKokkos::unpack_reverse_comm(int n, int *list, double *buf) { - int i,j,k,m; + meam_inst_kk->k_rho0.sync_host(); + meam_inst_kk->k_arho2b.sync_host(); + meam_inst_kk->k_arho1.sync_host(); + meam_inst_kk->k_arho2.sync_host(); + meam_inst_kk->k_arho3.sync_host(); + meam_inst_kk->k_arho3b.sync_host(); + meam_inst_kk->k_t_ave.sync_host(); + meam_inst_kk->k_tsq_ave.sync_host(); - m = 0; - for (i = 0; i < n; i++) { - j = list[i]; + int m = 0; + for (int i = 0; i < n; i++) { + const int j = list[i]; meam_inst_kk->h_rho0[j] += buf[m++]; meam_inst_kk->h_arho2b[j] += buf[m++]; meam_inst_kk->h_arho1(j,0) += buf[m++]; @@ -573,7 +690,7 @@ void PairMEAMKokkos::unpack_reverse_comm(int n, int *list, double *b meam_inst_kk->h_arho2(j,3) += buf[m++]; meam_inst_kk->h_arho2(j,4) += buf[m++]; meam_inst_kk->h_arho2(j,5) += buf[m++]; - for (k = 0; k < 10; k++) meam_inst_kk->h_arho3(j,k) += buf[m++]; + for (int k = 0; k < 10; k++) meam_inst_kk->h_arho3(j,k) += buf[m++]; meam_inst_kk->h_arho3b(j,0) += buf[m++]; meam_inst_kk->h_arho3b(j,1) += buf[m++]; meam_inst_kk->h_arho3b(j,2) += buf[m++]; @@ -584,46 +701,48 @@ void PairMEAMKokkos::unpack_reverse_comm(int n, int *list, double *b meam_inst_kk->h_tsq_ave(j,1) += buf[m++]; meam_inst_kk->h_tsq_ave(j,2) += buf[m++]; } + + meam_inst_kk->k_rho0.modify_host(); + meam_inst_kk->k_arho2b.modify_host(); + meam_inst_kk->k_arho1.modify_host(); + meam_inst_kk->k_arho2.modify_host(); + meam_inst_kk->k_arho3.modify_host(); + meam_inst_kk->k_arho3b.modify_host(); + meam_inst_kk->k_t_ave.modify_host(); + meam_inst_kk->k_tsq_ave.modify_host(); } /* ---------------------------------------------------------------------- - memory usage of local atom-based arrays + strip special bond flags from neighbor list entries + are not used with MEAM + need to do here so Fortran lib doesn't see them + done once per reneighbor so that neigh_f2c and neigh_c2f don't see them ------------------------------------------------------------------------- */ -template -double PairMEAMKokkos::memory_usage() -{ - double bytes = 11 * meam_inst_kk->nmax * sizeof(double); - bytes += (3 + 6 + 10 + 3 + 3 + 3) * meam_inst_kk->nmax * sizeof(double); - bytes += 3 * meam_inst_kk->maxneigh * sizeof(double); - return bytes; -} -template -KOKKOS_INLINE_FUNCTION -void PairMEAMKokkos::operator()(TagPairMEAMKernelNeighStrip, const int &ii) const { -/* ---------------------------------------------------------------------- - * strip special bond flags from neighbor list entries - * are not used with MEAM - * need to do here so Fortran lib doesn't see them - * done once per reneighbor so that neigh_f2c and neigh_c2f don't see them - * ------------------------------------------------------------------------- */ - const int i = d_ilist_half[ii]; - const int jnum_half = d_numneigh_half[i]; - const int jnum_full = d_numneigh_full[i]; - for (int jj = 0; jj < jnum_half; jj++) { - d_neighbors_half(i,jj) &= NEIGHMASK; - } - for (int jj = 0; jj < jnum_full; jj++) { - d_neighbors_full(i,jj) &= NEIGHMASK; - } -} template KOKKOS_INLINE_FUNCTION -void PairMEAMKokkos::operator()(TagPairMEAMKernelA, const int ii, int &n) const { - const int i = d_ilist_half[ii]; - n += d_numneigh_half[i]; +void PairMEAMKokkos::operator()(TagPairMEAMNeighStrip, const int &ii) const { + + const int i = d_ilist_half[ii]; + const int jnum_half = d_numneigh_half[i]; + const int jnum_full = d_numneigh_full[i]; + for (int jj = 0; jj < jnum_half; jj++) + d_neighbors_half(i,jj) &= NEIGHMASK; + for (int jj = 0; jj < jnum_full; jj++) + d_neighbors_full(i,jj) &= NEIGHMASK; } +/* ---------------------------------------------------------------------- */ + +template +KOKKOS_INLINE_FUNCTION +void PairMEAMKokkos::operator()(TagPairMEAMOffsets, const int ii, int &n) const { + const int i = d_ilist_half[ii]; + n += d_numneigh_half[i]; +} + +/* ---------------------------------------------------------------------- */ + namespace LAMMPS_NS { template class PairMEAMKokkos; #ifdef KOKKOS_ENABLE_CUDA diff --git a/src/KOKKOS/pair_meam_kokkos.h b/src/KOKKOS/pair_meam_kokkos.h index 114f4a1665..c18c9151f2 100644 --- a/src/KOKKOS/pair_meam_kokkos.h +++ b/src/KOKKOS/pair_meam_kokkos.h @@ -1,6 +1,6 @@ /* -*- c++ -*- ---------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator - http://lammps.sandia.gov, Sandia National Laboratories + https://www.lammps.org/, Sandia National Laboratories Steve Plimpton, sjplimp@sandia.gov Copyright (2003) Sandia Corporation. Under the terms of Contract @@ -12,31 +12,33 @@ ------------------------------------------------------------------------- */ #ifdef PAIR_CLASS - +// clang-format off PairStyle(meam/c/kk,PairMEAMKokkos) PairStyle(meam/c/kk/device,PairMEAMKokkos) PairStyle(meam/c/kk/host,PairMEAMKokkos) PairStyle(meam/kk,PairMEAMKokkos) PairStyle(meam/kk/device,PairMEAMKokkos) PairStyle(meam/kk/host,PairMEAMKokkos) - +// clang-format on #else -#ifndef LMP_PAIR_MEAMC_KOKKOS_H -#define LMP_PAIR_MEAMC_KOKKOS_H +// clang-format off +#ifndef LMP_PAIR_MEAM_KOKKOS_H +#define LMP_PAIR_MEAM_KOKKOS_H #include "kokkos_base.h" #include "pair_kokkos.h" #include "pair_meam.h" -#include "neigh_list_kokkos.h" #include "meam_kokkos.h" - namespace LAMMPS_NS { -struct TagPairMEAMKernelNeighStrip{}; -struct TagPairMEAMKernelA{}; + +struct TagPairMEAMNeighStrip{}; +struct TagPairMEAMOffsets{}; struct TagPairMEAMPackForwardComm{}; struct TagPairMEAMUnpackForwardComm{}; +struct TagPairMEAMPackReverseComm{}; +struct TagPairMEAMUnpackReverseComm{}; template class MEAMKokkos; @@ -48,13 +50,13 @@ class PairMEAMKokkos : public PairMEAM, public KokkosBase { enum {COUL_FLAG=0}; typedef DeviceType device_type; typedef ArrayTypes AT; - //typedef EV_FLOAT value_type; + typedef int value_type; PairMEAMKokkos(class LAMMPS *); - virtual ~PairMEAMKokkos(); - void compute(int, int); - void coeff(int, char **); - void init_style(); + ~PairMEAMKokkos() override; + void compute(int, int) override; + void coeff(int, char **) override; + void init_style() override; KOKKOS_INLINE_FUNCTION void operator()(TagPairMEAMPackForwardComm, const int&) const; @@ -63,104 +65,59 @@ class PairMEAMKokkos : public PairMEAM, public KokkosBase { void operator()(TagPairMEAMUnpackForwardComm, const int&) const; KOKKOS_INLINE_FUNCTION - void operator()(TagPairMEAMKernelNeighStrip, const int&) const; + void operator()(TagPairMEAMPackReverseComm, const int&) const; KOKKOS_INLINE_FUNCTION - void operator()(TagPairMEAMKernelA, const int, int&) const; + void operator()(TagPairMEAMUnpackReverseComm, const int&) const; + + KOKKOS_INLINE_FUNCTION + void operator()(TagPairMEAMNeighStrip, const int&) const; + + KOKKOS_INLINE_FUNCTION + void operator()(TagPairMEAMOffsets, const int, int&) const; int pack_forward_comm_kokkos(int, DAT::tdual_int_2d, int, DAT::tdual_xfloat_1d&, - int, int *); - void unpack_forward_comm_kokkos(int, int, DAT::tdual_xfloat_1d&); - int pack_forward_comm(int, int *, double *, int, int *); - void unpack_forward_comm(int, int, double *); - int pack_reverse_comm(int, int, double *); - void unpack_reverse_comm(int, int *, double *); - double memory_usage(); + int, int *) override; + int pack_forward_comm(int, int *, double *, int, int *) override; + void unpack_forward_comm_kokkos(int, int, DAT::tdual_xfloat_1d&) override; + void unpack_forward_comm(int, int, double *) override; + int pack_reverse_comm_kokkos(int, int, DAT::tdual_xfloat_1d&) override; + int pack_reverse_comm(int, int, double *) override; + void unpack_reverse_comm_kokkos(int, DAT::tdual_int_2d, + int, DAT::tdual_xfloat_1d&) override; + void unpack_reverse_comm(int, int *, double *) override; protected: class MEAMKokkos *meam_inst_kk; - typename AT::t_x_array_randomread x; + typename AT::t_x_array x; typename AT::t_f_array f; - typename AT::t_int_1d_randomread type; + typename AT::t_int_1d type; DAT::tdual_efloat_1d k_eatom; DAT::tdual_virial_array k_vatom; - typename ArrayTypes::t_efloat_1d d_eatom; - typename ArrayTypes::t_virial_array d_vatom; + typename AT::t_efloat_1d d_eatom; + typename AT::t_virial_array d_vatom; - DAT::tdual_int_1d k_offset; - HAT::t_int_1d h_offset; - typename AT::t_int_1d_randomread d_offset; + typename AT::t_int_1d d_offset; DAT::tdual_int_1d k_map; - typename AT::t_int_1d_randomread d_map; - typename AT::t_int_1d_randomread d_ilist_half; - typename AT::t_int_1d_randomread d_numneigh_half; + typename AT::t_int_1d d_map; + typename AT::t_int_2d d_scale; + typename AT::t_int_1d d_ilist_half; + typename AT::t_int_1d d_numneigh_half; typename AT::t_neighbors_2d d_neighbors_half; - typename AT::t_int_1d_randomread d_numneigh_full; + typename AT::t_int_1d d_numneigh_full; typename AT::t_neighbors_2d d_neighbors_full; typename AT::t_int_2d d_sendlist; typename AT::t_xfloat_1d_um v_buf; - + + int iswap,first; int neighflag,nlocal,nall,eflag,vflag; - int iswap; - int first; friend void pair_virial_fdotr_compute(PairMEAMKokkos*); - }; } - #endif #endif -/* ERROR/WARNING messages: - -E: MEAM library error %d - -A call to the MEAM Fortran library returned an error. - -E: Illegal ... command - -Self-explanatory. Check the input script syntax and compare to the -documentation for the command. You can use -echo screen as a -command-line option when running LAMMPS to see the offending line. - -E: Incorrect args for pair coefficients - -Self-explanatory. Check the input script or data file. - -E: Pair style MEAM requires newton pair on - -See the newton command. This is a restriction to use the MEAM -potential. - -E: Cannot open MEAM potential file %s - -The specified MEAM potential file cannot be opened. Check that the -path and name are correct. - -E: Incorrect format in MEAM potential file - -Incorrect number of words per line in the potential file. - -E: Unrecognized lattice type in MEAM file 1 - -The lattice type in an entry of the MEAM library file is not -valid. - -E: Did not find all elements in MEAM library file - -The requested elements were not found in the MEAM file. - -E: Keyword %s in MEAM parameter file not recognized - -Self-explanatory. - -E: Unrecognized lattice type in MEAM file 2 - -The lattice type in an entry of the MEAM parameter file is not -valid. - -*/ diff --git a/src/MEAM/meam.h b/src/MEAM/meam.h index 8b94ac0084..8a2f43e354 100644 --- a/src/MEAM/meam.h +++ b/src/MEAM/meam.h @@ -27,7 +27,9 @@ typedef enum { FCC, BCC, HCP, DIM, DIA, DIA3, B1, C11, L12, B2, CH4, LIN, ZIG, T class MEAM { public: MEAM(Memory *mem); - ~MEAM(); + virtual ~MEAM(); + + int copymode; protected: Memory *memory; @@ -285,8 +287,8 @@ class MEAM { double *rozero, int *ibar); void meam_setup_param(int which, double value, int nindex, int *index /*index(3)*/, int *errorflag); - void meam_setup_done(double *cutmax); - void meam_dens_setup(int atom_nmax, int nall, int n_neigh); + virtual void meam_setup_done(double *cutmax); + virtual void meam_dens_setup(int atom_nmax, int nall, int n_neigh); void meam_dens_init(int i, int ntype, int *type, int *fmap, double **x, int numneigh, int *firstneigh, int numneigh_full, int *firstneigh_full, int fnoffset); void meam_dens_final(int nlocal, int eflag_either, int eflag_global, int eflag_atom, diff --git a/src/MEAM/meam_impl.cpp b/src/MEAM/meam_impl.cpp index 499a2b1520..d0d81cee88 100644 --- a/src/MEAM/meam_impl.cpp +++ b/src/MEAM/meam_impl.cpp @@ -36,6 +36,7 @@ MEAM::MEAM(Memory* mem) maxneigh = 0; scrfcn = dscrfcn = fcpair = nullptr; + copymode = 0; neltypes = 0; for (int i = 0; i < maxelt; i++) { @@ -53,6 +54,8 @@ MEAM::MEAM(Memory* mem) MEAM::~MEAM() { + if (copymode) return; + memory->destroy(this->phirar6); memory->destroy(this->phirar5); memory->destroy(this->phirar4); diff --git a/src/MEAM/pair_meam.cpp b/src/MEAM/pair_meam.cpp index ab027dcb89..6cbe5c69b9 100644 --- a/src/MEAM/pair_meam.cpp +++ b/src/MEAM/pair_meam.cpp @@ -75,7 +75,8 @@ PairMEAM::~PairMEAM() { if (copymode) return; - delete meam_inst; + if (meam_inst) + delete meam_inst; if (allocated) { memory->destroy(setflag); diff --git a/src/MEAM/pair_meam.h b/src/MEAM/pair_meam.h index ffe8045ac9..304e7eb41f 100644 --- a/src/MEAM/pair_meam.h +++ b/src/MEAM/pair_meam.h @@ -52,7 +52,7 @@ class PairMEAM : public Pair { double **scale; // scaling factor for adapt - virtual void allocate(); + void allocate(); void read_files(const std::string &, const std::string &); void read_global_meam_file(const std::string &); void read_user_meam_file(const std::string &); diff --git a/src/pair.cpp b/src/pair.cpp index 44f23745d9..5ce4dc2d32 100644 --- a/src/pair.cpp +++ b/src/pair.cpp @@ -126,6 +126,7 @@ Pair::Pair(LAMMPS *lmp) : Pointers(lmp) datamask_modify = ALL_MASK; kokkosable = 0; + reverse_comm_device = 0; copymode = 0; } diff --git a/src/pair.h b/src/pair.h index 4763a225d2..5bad9e14a3 100644 --- a/src/pair.h +++ b/src/pair.h @@ -123,6 +123,7 @@ class Pair : protected Pointers { ExecutionSpace execution_space; unsigned int datamask_read, datamask_modify; int kokkosable; // 1 if Kokkos pair + int reverse_comm_device; // 1 if reverse comm on Device Pair(class LAMMPS *); ~Pair() override; From 23ee2a97fa2907040cef8b8f5d266fec7f43d515 Mon Sep 17 00:00:00 2001 From: Stan Moore Date: Fri, 1 Jul 2022 11:24:50 -0600 Subject: [PATCH 499/585] Whitespace --- src/KOKKOS/meam_dens_init_kokkos.h | 2 +- src/KOKKOS/meam_funcs_kokkos.h | 6 +++--- src/KOKKOS/meam_kokkos.h | 8 ++++---- src/KOKKOS/pair_meam_kokkos.cpp | 8 ++++---- src/KOKKOS/pair_meam_kokkos.h | 8 ++++---- 5 files changed, 16 insertions(+), 16 deletions(-) diff --git a/src/KOKKOS/meam_dens_init_kokkos.h b/src/KOKKOS/meam_dens_init_kokkos.h index bcf0e7433e..aa0be60cde 100644 --- a/src/KOKKOS/meam_dens_init_kokkos.h +++ b/src/KOKKOS/meam_dens_init_kokkos.h @@ -14,7 +14,7 @@ void MEAMKokkos::operator()(TagMEAMDensInit, const int &i ii = d_ilist_half[i]; offsetval = d_offset[i]; // compute screening function and derivatives - this->template getscreen(ii, offsetval, x, d_numneigh_half, + this->template getscreen(ii, offsetval, x, d_numneigh_half, d_numneigh_full, ntype, type, d_map); // calculate intermediate density terms to be communicated diff --git a/src/KOKKOS/meam_funcs_kokkos.h b/src/KOKKOS/meam_funcs_kokkos.h index f02def0676..0e58e85db1 100644 --- a/src/KOKKOS/meam_funcs_kokkos.h +++ b/src/KOKKOS/meam_funcs_kokkos.h @@ -29,9 +29,9 @@ using namespace MathSpecialKokkos; // 4 => G = sqrt(1+gamma) // -5 => G = +-sqrt(abs(1+gamma)) // -template +template KOKKOS_INLINE_FUNCTION -double MEAMKokkos::G_gam(const double gamma, const int ibar, int &errorflag) const +double MEAMKokkos::G_gam(const double gamma, const int ibar, int &errorflag) const { double gsmooth_switchpoint; @@ -74,7 +74,7 @@ double MEAMKokkos::G_gam(const double gamma, const int ibar, int &er // template KOKKOS_INLINE_FUNCTION -double MEAMKokkos::dG_gam(const double gamma, const int ibar, double& dG) const +double MEAMKokkos::dG_gam(const double gamma, const int ibar, double& dG) const { double gsmooth_switchpoint; double G; diff --git a/src/KOKKOS/meam_kokkos.h b/src/KOKKOS/meam_kokkos.h index fb34f45b5c..57002b032c 100644 --- a/src/KOKKOS/meam_kokkos.h +++ b/src/KOKKOS/meam_kokkos.h @@ -33,7 +33,7 @@ class MEAMKokkos : public MEAM template KOKKOS_INLINE_FUNCTION void operator()(TagMEAMDensInit, const int&) const; - + KOKKOS_INLINE_FUNCTION void operator()(TagMEAMZero, const int&) const; @@ -73,8 +73,8 @@ class MEAMKokkos : public MEAM int, int); void meam_dens_final(int, int, int, int, typename ArrayTypes::t_efloat_1d, int, typename AT::t_int_1d, typename AT::t_int_1d, typename AT::t_int_2d, int&, EV_FLOAT&); - void meam_force(int, int, int, int, int, typename ArrayTypes::t_efloat_1d, - int, typename AT::t_int_1d, typename AT::t_int_1d, typename AT::t_x_array, typename AT::t_int_1d, + void meam_force(int, int, int, int, int, typename ArrayTypes::t_efloat_1d, + int, typename AT::t_int_1d, typename AT::t_int_1d, typename AT::t_x_array, typename AT::t_int_1d, typename AT::t_int_1d, typename AT::t_f_array, typename ArrayTypes::t_virial_array, typename AT::t_int_1d, typename AT::t_int_1d, typename AT::t_neighbors_2d, typename AT::t_neighbors_2d, int, int, EV_FLOAT&); @@ -100,7 +100,7 @@ class MEAMKokkos : public MEAM KOKKOS_INLINE_FUNCTION double zbl(const double, const int, const int) const; KOKKOS_INLINE_FUNCTION - double embedding(const double, const double, const double, double&) const; + double embedding(const double, const double, const double, double&) const; KOKKOS_INLINE_FUNCTION double erose(const double, const double, const double, const double, const double, const double, const int) const; KOKKOS_INLINE_FUNCTION diff --git a/src/KOKKOS/pair_meam_kokkos.cpp b/src/KOKKOS/pair_meam_kokkos.cpp index 33343f4af5..1879422f60 100644 --- a/src/KOKKOS/pair_meam_kokkos.cpp +++ b/src/KOKKOS/pair_meam_kokkos.cpp @@ -135,7 +135,7 @@ void PairMEAMKokkos::compute(int eflag_in, int vflag_in) // loop over my atoms followed by communication int errorflag = 0; - + d_offset = typename AT::t_int_1d("pair:offset",inum_half+1); { // local variables for lambda capture @@ -352,7 +352,7 @@ void PairMEAMKokkos::operator()(TagPairMEAMPackForwardComm, const in v_buf[m++] = meam_inst_kk->d_tsq_ave(j,0); v_buf[m++] = meam_inst_kk->d_tsq_ave(j,1); v_buf[m++] = meam_inst_kk->d_tsq_ave(j,2); -} +} /* ---------------------------------------------------------------------- */ @@ -402,7 +402,7 @@ void PairMEAMKokkos::operator()(TagPairMEAMUnpackForwardComm, const meam_inst_kk->d_tsq_ave(i+first,2) = v_buf[m++]; } -/* ---------------------------------------------------------------------- */ +/* ---------------------------------------------------------------------- */ template int PairMEAMKokkos::pack_forward_comm(int n, int *list, double *buf, @@ -738,7 +738,7 @@ template KOKKOS_INLINE_FUNCTION void PairMEAMKokkos::operator()(TagPairMEAMOffsets, const int ii, int &n) const { const int i = d_ilist_half[ii]; - n += d_numneigh_half[i]; + n += d_numneigh_half[i]; } /* ---------------------------------------------------------------------- */ diff --git a/src/KOKKOS/pair_meam_kokkos.h b/src/KOKKOS/pair_meam_kokkos.h index c18c9151f2..fef4266b8a 100644 --- a/src/KOKKOS/pair_meam_kokkos.h +++ b/src/KOKKOS/pair_meam_kokkos.h @@ -92,15 +92,15 @@ class PairMEAMKokkos : public PairMEAM, public KokkosBase { typename AT::t_x_array x; typename AT::t_f_array f; typename AT::t_int_1d type; - + DAT::tdual_efloat_1d k_eatom; DAT::tdual_virial_array k_vatom; typename AT::t_efloat_1d d_eatom; typename AT::t_virial_array d_vatom; typename AT::t_int_1d d_offset; - - DAT::tdual_int_1d k_map; + + DAT::tdual_int_1d k_map; typename AT::t_int_1d d_map; typename AT::t_int_2d d_scale; typename AT::t_int_1d d_ilist_half; @@ -111,7 +111,7 @@ class PairMEAMKokkos : public PairMEAM, public KokkosBase { typename AT::t_int_2d d_sendlist; typename AT::t_xfloat_1d_um v_buf; - int iswap,first; + int iswap,first; int neighflag,nlocal,nall,eflag,vflag; friend void pair_virial_fdotr_compute(PairMEAMKokkos*); From 27165f82b4f1454f04d8d80748c3605ef65e9575 Mon Sep 17 00:00:00 2001 From: Stan Moore Date: Fri, 1 Jul 2022 12:09:48 -0600 Subject: [PATCH 500/585] Fix urls and license --- src/KOKKOS/meam_dens_final_kokkos.h | 14 ++++++++++++++ src/KOKKOS/meam_dens_init_kokkos.h | 14 ++++++++++++++ src/KOKKOS/meam_funcs_kokkos.h | 3 ++- src/KOKKOS/meam_impl_kokkos.h | 3 ++- src/KOKKOS/meam_kokkos.h | 13 +++++++++++++ src/KOKKOS/meam_setup_done_kokkos.h | 14 ++++++++++++++ src/KOKKOS/pair_meam_kokkos.cpp | 1 + 7 files changed, 60 insertions(+), 2 deletions(-) diff --git a/src/KOKKOS/meam_dens_final_kokkos.h b/src/KOKKOS/meam_dens_final_kokkos.h index 4a212d3597..aede2cbcc7 100644 --- a/src/KOKKOS/meam_dens_final_kokkos.h +++ b/src/KOKKOS/meam_dens_final_kokkos.h @@ -1,3 +1,17 @@ +// clang-format off +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + https://www.lammps.org/, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + #include "meam_kokkos.h" #include "math_special.h" diff --git a/src/KOKKOS/meam_dens_init_kokkos.h b/src/KOKKOS/meam_dens_init_kokkos.h index aa0be60cde..4342cc1ba1 100644 --- a/src/KOKKOS/meam_dens_init_kokkos.h +++ b/src/KOKKOS/meam_dens_init_kokkos.h @@ -1,3 +1,17 @@ +// clang-format off +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + https://www.lammps.org/, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + #include "meam_kokkos.h" #include "math_special_kokkos.h" diff --git a/src/KOKKOS/meam_funcs_kokkos.h b/src/KOKKOS/meam_funcs_kokkos.h index 0e58e85db1..a20f0c9182 100644 --- a/src/KOKKOS/meam_funcs_kokkos.h +++ b/src/KOKKOS/meam_funcs_kokkos.h @@ -1,6 +1,7 @@ +// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator - http://lammps.sandia.gov, Sandia National Laboratories + https://www.lammps.org/, Sandia National Laboratories Steve Plimpton, sjplimp@sandia.gov Copyright (2003) Sandia Corporation. Under the terms of Contract diff --git a/src/KOKKOS/meam_impl_kokkos.h b/src/KOKKOS/meam_impl_kokkos.h index 0a787ba2eb..be69f247be 100644 --- a/src/KOKKOS/meam_impl_kokkos.h +++ b/src/KOKKOS/meam_impl_kokkos.h @@ -1,6 +1,7 @@ +// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator - http://lammps.sandia.gov, Sandia National Laboratories + https://www.lammps.org/, Sandia National Laboratories Steve Plimpton, sjplimp@sandia.gov Copyright (2003) Sandia Corporation. Under the terms of Contract diff --git a/src/KOKKOS/meam_kokkos.h b/src/KOKKOS/meam_kokkos.h index 57002b032c..74f815e912 100644 --- a/src/KOKKOS/meam_kokkos.h +++ b/src/KOKKOS/meam_kokkos.h @@ -1,3 +1,16 @@ +/* -*- c++ -*- ---------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + https://www.lammps.org/, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + #ifndef LMP_MEAMKOKKOS_H #define LMP_MEAMKOKKOS_H diff --git a/src/KOKKOS/meam_setup_done_kokkos.h b/src/KOKKOS/meam_setup_done_kokkos.h index 7d5de12427..8b705217b0 100644 --- a/src/KOKKOS/meam_setup_done_kokkos.h +++ b/src/KOKKOS/meam_setup_done_kokkos.h @@ -1,3 +1,17 @@ +// clang-format off +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + https://www.lammps.org/, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + #include "meam_kokkos.h" template diff --git a/src/KOKKOS/pair_meam_kokkos.cpp b/src/KOKKOS/pair_meam_kokkos.cpp index 1879422f60..47e5ab8f96 100644 --- a/src/KOKKOS/pair_meam_kokkos.cpp +++ b/src/KOKKOS/pair_meam_kokkos.cpp @@ -1,3 +1,4 @@ +// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories From becd876166ca3af8cf4c62a4fd6cefe1c09414ff Mon Sep 17 00:00:00 2001 From: Stan Moore Date: Fri, 1 Jul 2022 12:28:13 -0600 Subject: [PATCH 501/585] small tweaks --- src/KOKKOS/math_special_kokkos.cpp | 195 +---------------------------- src/KOKKOS/math_special_kokkos.h | 5 +- 2 files changed, 5 insertions(+), 195 deletions(-) diff --git a/src/KOKKOS/math_special_kokkos.cpp b/src/KOKKOS/math_special_kokkos.cpp index eca64fbb4e..84c584a5cc 100644 --- a/src/KOKKOS/math_special_kokkos.cpp +++ b/src/KOKKOS/math_special_kokkos.cpp @@ -1,202 +1,11 @@ // clang-format off -#include "math_special_kokkos.h" +#include "math_special_kokkos.h" #include -#include // IWYU pragma: keep -#include +#include using namespace LAMMPS_NS; -static constexpr int nmaxfactorial = 167; - -/* ---------------------------------------------------------------------- - factorial n table, size nmaxfactorial+1 -------------------------------------------------------------------------- */ - -static const double nfac_table[] = { - 1, - 1, - 2, - 6, - 24, - 120, - 720, - 5040, - 40320, - 362880, - 3628800, - 39916800, - 479001600, - 6227020800, - 87178291200, - 1307674368000, - 20922789888000, - 355687428096000, - 6.402373705728e+15, - 1.21645100408832e+17, - 2.43290200817664e+18, - 5.10909421717094e+19, - 1.12400072777761e+21, - 2.5852016738885e+22, - 6.20448401733239e+23, - 1.5511210043331e+25, - 4.03291461126606e+26, - 1.08888694504184e+28, - 3.04888344611714e+29, - 8.8417619937397e+30, - 2.65252859812191e+32, - 8.22283865417792e+33, - 2.63130836933694e+35, - 8.68331761881189e+36, - 2.95232799039604e+38, - 1.03331479663861e+40, - 3.71993326789901e+41, - 1.37637530912263e+43, - 5.23022617466601e+44, - 2.03978820811974e+46, - 8.15915283247898e+47, - 3.34525266131638e+49, - 1.40500611775288e+51, - 6.04152630633738e+52, - 2.65827157478845e+54, - 1.1962222086548e+56, - 5.50262215981209e+57, - 2.58623241511168e+59, - 1.24139155925361e+61, - 6.08281864034268e+62, - 3.04140932017134e+64, - 1.55111875328738e+66, - 8.06581751709439e+67, - 4.27488328406003e+69, - 2.30843697339241e+71, - 1.26964033536583e+73, - 7.10998587804863e+74, - 4.05269195048772e+76, - 2.35056133128288e+78, - 1.3868311854569e+80, - 8.32098711274139e+81, - 5.07580213877225e+83, - 3.14699732603879e+85, - 1.98260831540444e+87, - 1.26886932185884e+89, - 8.24765059208247e+90, - 5.44344939077443e+92, - 3.64711109181887e+94, - 2.48003554243683e+96, - 1.71122452428141e+98, - 1.19785716699699e+100, - 8.50478588567862e+101, - 6.12344583768861e+103, - 4.47011546151268e+105, - 3.30788544151939e+107, - 2.48091408113954e+109, - 1.88549470166605e+111, - 1.45183092028286e+113, - 1.13242811782063e+115, - 8.94618213078297e+116, - 7.15694570462638e+118, - 5.79712602074737e+120, - 4.75364333701284e+122, - 3.94552396972066e+124, - 3.31424013456535e+126, - 2.81710411438055e+128, - 2.42270953836727e+130, - 2.10775729837953e+132, - 1.85482642257398e+134, - 1.65079551609085e+136, - 1.48571596448176e+138, - 1.3520015276784e+140, - 1.24384140546413e+142, - 1.15677250708164e+144, - 1.08736615665674e+146, - 1.03299784882391e+148, - 9.91677934870949e+149, - 9.61927596824821e+151, - 9.42689044888324e+153, - 9.33262154439441e+155, - 9.33262154439441e+157, - 9.42594775983835e+159, - 9.61446671503512e+161, - 9.90290071648618e+163, - 1.02990167451456e+166, - 1.08139675824029e+168, - 1.14628056373471e+170, - 1.22652020319614e+172, - 1.32464181945183e+174, - 1.44385958320249e+176, - 1.58824554152274e+178, - 1.76295255109024e+180, - 1.97450685722107e+182, - 2.23119274865981e+184, - 2.54355973347219e+186, - 2.92509369349301e+188, - 3.3931086844519e+190, - 3.96993716080872e+192, - 4.68452584975429e+194, - 5.5745857612076e+196, - 6.68950291344912e+198, - 8.09429852527344e+200, - 9.8750442008336e+202, - 1.21463043670253e+205, - 1.50614174151114e+207, - 1.88267717688893e+209, - 2.37217324288005e+211, - 3.01266001845766e+213, - 3.8562048236258e+215, - 4.97450422247729e+217, - 6.46685548922047e+219, - 8.47158069087882e+221, - 1.118248651196e+224, - 1.48727070609069e+226, - 1.99294274616152e+228, - 2.69047270731805e+230, - 3.65904288195255e+232, - 5.01288874827499e+234, - 6.91778647261949e+236, - 9.61572319694109e+238, - 1.34620124757175e+241, - 1.89814375907617e+243, - 2.69536413788816e+245, - 3.85437071718007e+247, - 5.5502938327393e+249, - 8.04792605747199e+251, - 1.17499720439091e+254, - 1.72724589045464e+256, - 2.55632391787286e+258, - 3.80892263763057e+260, - 5.71338395644585e+262, - 8.62720977423323e+264, - 1.31133588568345e+267, - 2.00634390509568e+269, - 3.08976961384735e+271, - 4.78914290146339e+273, - 7.47106292628289e+275, - 1.17295687942641e+278, - 1.85327186949373e+280, - 2.94670227249504e+282, - 4.71472363599206e+284, - 7.59070505394721e+286, - 1.22969421873945e+289, - 2.0044015765453e+291, - 3.28721858553429e+293, - 5.42391066613159e+295, - 9.00369170577843e+297, - 1.503616514865e+300, // nmaxfactorial = 167 -}; - -/* ---------------------------------------------------------------------- - factorial n vial lookup from precomputed table -------------------------------------------------------------------------- */ - -double MathSpecialKokkos::factorial(const int n) -{ - if (n < 0 || n > nmaxfactorial) - return std::numeric_limits::quiet_NaN(); - - return nfac_table[n]; -} - - /* Library libcerf: * Compute complex error functions, based on a new implementation of * Faddeeva's w_of_z. Also provide Dawson and Voigt functions. diff --git a/src/KOKKOS/math_special_kokkos.h b/src/KOKKOS/math_special_kokkos.h index 0264cb4134..35a8bf56c5 100644 --- a/src/KOKKOS/math_special_kokkos.h +++ b/src/KOKKOS/math_special_kokkos.h @@ -1,3 +1,4 @@ +// clang-format off /* -*- c++ -*- ---------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -14,8 +15,8 @@ #ifndef LMP_MATH_SPECIAL_KOKKOS_H #define LMP_MATH_SPECIAL_KOKKOS_H -#include "kokkos_type.h" #include +#include "kokkos_type.h" namespace LAMMPS_NS { @@ -171,7 +172,7 @@ namespace MathSpecialKokkos { static inline double expmsq(double x) { x *= x; - x *= 1.4426950408889634074; // log_2(e) + x *= 1.4426950408889634074; // log_2(e) #if defined(__BYTE_ORDER__) && __BYTE_ORDER__ == __ORDER_LITTLE_ENDIAN__ return (x < 1023.0) ? exp2_x86(-x) : 0.0; #else From d385a9be9d7b519d04b58ab7b0c7b8ed272d22d9 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Fri, 1 Jul 2022 13:13:57 -0600 Subject: [PATCH 502/585] finished debug of induce iterations --- examples/amoeba/in.water_box.amoeba | 4 +-- src/AMOEBA/amoeba_induce.cpp | 8 +---- src/AMOEBA/pair_amoeba.cpp | 49 ++++++----------------------- 3 files changed, 13 insertions(+), 48 deletions(-) diff --git a/examples/amoeba/in.water_box.amoeba b/examples/amoeba/in.water_box.amoeba index be21af5f9a..9c46f9d5c8 100644 --- a/examples/amoeba/in.water_box.amoeba +++ b/examples/amoeba/in.water_box.amoeba @@ -43,5 +43,5 @@ dump_modify 1 sort id fix 1 all nve -thermo 1 -run 5 +thermo 10 +run 100 diff --git a/src/AMOEBA/amoeba_induce.cpp b/src/AMOEBA/amoeba_induce.cpp index ec9cd1f1d3..9398cbf593 100644 --- a/src/AMOEBA/amoeba_induce.cpp +++ b/src/AMOEBA/amoeba_induce.cpp @@ -25,10 +25,6 @@ #include "memory.h" #include "error.h" -// DEBUG - -#include "update.h" - #include #include @@ -385,9 +381,7 @@ void PairAmoeba::induce() } } - // DEBUG - - printf("CG iteration count = %d\n",iter); + // if (comm->me == 0) printf("CG iteration count = %d\n",iter); // terminate the calculation if dipoles failed to converge // NOTE: could make this an error diff --git a/src/AMOEBA/pair_amoeba.cpp b/src/AMOEBA/pair_amoeba.cpp index f5281e964b..73a6b52162 100644 --- a/src/AMOEBA/pair_amoeba.cpp +++ b/src/AMOEBA/pair_amoeba.cpp @@ -1750,20 +1750,20 @@ void PairAmoeba::precond_neigh() int *ilist,*jlist,*numneigh,**firstneigh; int *neighptr; - // set cutoffs and taper coeffs - // add skin to cutoff, same as for main neighbor list - // note that Tinker (and thus LAMMPS) does not apply the + // DEBUG + + if (comm->me == 0.0) printf("Reneighbor on step %ld\n",update->ntimestep); + + // NOTE: no skin added to cutoff for this shorter neighbor list + // also note that Tinker (and thus LAMMPS) does not apply the // distance cutoff in the CG iterations in induce.cpp, - // all interactions in this skin-extended neigh list are + // rather all interactions in the precond neigh list are // used every step until the neighbor list is rebuilt, - // this means the cut+skin distance is not exactly enforced, - // neighbors outside may contribute, neighbors inside may not + // this means the cutoff distance is not exactly enforced, + // on a later step atoms outside may contribute, atoms inside may not choose(USOLV); - double off = sqrt(off2); - off2 = (off + neighbor->skin) * (off + neighbor->skin); - // atoms and neighbor list double **x = atom->x; @@ -1776,13 +1776,6 @@ void PairAmoeba::precond_neigh() // store all induce neighs of owned atoms within shorter cutoff // scan longer-cutoff neighbor list of I - - // DEBUG - - int *ncount; - memory->create(ncount,atom->nlocal,"amoeba:ncount"); - for (int i = 0; i < atom->nlocal; i++) ncount[i] = 0; - ipage_precond->reset(); for (ii = 0; ii < inum; ii++) { @@ -1806,35 +1799,13 @@ void PairAmoeba::precond_neigh() delz = ztmp - x[j][2]; rsq = delx*delx + dely*dely + delz*delz; - if (rsq < off2) { - neighptr[n++] = jlist[jj]; - - // DEBUG - - int jcount = atom->map(atom->tag[j]); - ncount[jcount]++; - } + if (rsq < off2) neighptr[n++] = jlist[jj]; } firstneigh_precond[i] = neighptr; numneigh_precond[i] = n; ipage_precond->vgot(n); - - // DEBUG - - ncount[i] += n; } - - // DEBUG - - if (update->ntimestep == 0) { - for (int i = 1; i <= atom->nlocal; i++) { - int ilocal = atom->map(i); - printf("PRECOND id %d ilocal %d numneigh %d\n",i,ilocal,ncount[ilocal]); - } - } - - memory->destroy(ncount); } From 2bfbd6fba1c3a23995c1ffb21928a00df8a43cd9 Mon Sep 17 00:00:00 2001 From: Stan Gerald Moore Date: Fri, 1 Jul 2022 13:17:50 -0600 Subject: [PATCH 503/585] Update Kokkos library in LAMMPS to v3.6.1 --- lib/kokkos/CHANGELOG.md | 16 ++++ lib/kokkos/CMakeLists.txt | 2 +- lib/kokkos/Makefile.kokkos | 2 +- lib/kokkos/algorithms/src/Kokkos_Sort.hpp | 79 ++++++++----------- lib/kokkos/algorithms/unit_tests/TestSort.hpp | 58 ++++++++++++++ .../containers/src/Kokkos_ScatterView.hpp | 40 +--------- lib/kokkos/containers/src/Kokkos_Vector.hpp | 18 ++--- .../containers/unit_tests/TestVector.hpp | 17 ++++ lib/kokkos/core/src/CMakeLists.txt | 1 + .../core/src/Cuda/Kokkos_Cuda_Instance.cpp | 9 +++ lib/kokkos/core/src/Cuda/Kokkos_Cuda_View.hpp | 2 +- .../core/src/HIP/Kokkos_HIP_Instance.cpp | 4 +- .../core/src/HIP/Kokkos_HIP_KernelLaunch.hpp | 2 + lib/kokkos/core/src/HIP/Kokkos_HIP_Locks.cpp | 3 +- lib/kokkos/core/src/HIP/Kokkos_HIP_Space.cpp | 9 +++ lib/kokkos/core/src/HPX/Kokkos_HPX.cpp | 9 +++ lib/kokkos/core/src/Kokkos_Cuda.hpp | 1 + lib/kokkos/core/src/Kokkos_HIP_Space.hpp | 3 + lib/kokkos/core/src/Kokkos_HPX.hpp | 1 + lib/kokkos/core/src/Kokkos_OpenMP.hpp | 1 + lib/kokkos/core/src/Kokkos_OpenMPTarget.hpp | 3 + lib/kokkos/core/src/Kokkos_SYCL.hpp | 3 + lib/kokkos/core/src/Kokkos_Serial.hpp | 1 + lib/kokkos/core/src/Kokkos_Threads.hpp | 1 + .../core/src/OpenMP/Kokkos_OpenMP_Exec.cpp | 14 +++- .../core/src/OpenMP/Kokkos_OpenMP_Exec.hpp | 10 ++- .../core/src/SYCL/Kokkos_SYCL_Instance.hpp | 2 +- .../core/src/Threads/Kokkos_ThreadsExec.cpp | 74 ++++++++++++++--- .../core/src/Threads/Kokkos_ThreadsExec.hpp | 5 +- .../src/impl/Kokkos_Profiling_Interface.hpp | 7 +- lib/kokkos/core/src/impl/Kokkos_Serial.cpp | 9 +++ .../core/src/impl/Kokkos_ViewMapping.hpp | 59 +++++++------- .../core/src/impl/Kokkos_ViewTracker.hpp | 2 + lib/kokkos/core/unit_test/TestViewAPI.hpp | 14 ++++ lib/kokkos/core/unit_test/TestViewAPI_e.hpp | 29 +++++++ .../unit_test/tools/TestEventCorrectness.hpp | 15 ++-- lib/kokkos/master_history.txt | 1 + 37 files changed, 363 insertions(+), 163 deletions(-) diff --git a/lib/kokkos/CHANGELOG.md b/lib/kokkos/CHANGELOG.md index dfbe22edde..a908507704 100644 --- a/lib/kokkos/CHANGELOG.md +++ b/lib/kokkos/CHANGELOG.md @@ -1,5 +1,21 @@ # Change Log +## [3.6.01](https://github.com/kokkos/kokkos/tree/3.6.01) (2022-05-23) +[Full Changelog](https://github.com/kokkos/kokkos/compare/3.6.00...3.6.01) + +### Bug Fixes: +- Fix Threads: Fix serial resizing scratch space (3.6.01 cherry-pick) [\#5109](https://github.com/kokkos/kokkos/pull/5109) +- Fix ScatterMin/ScatterMax to use proper atomics (3.6.01 cherry-pick) [\#5046](https://github.com/kokkos/kokkos/pull/5046) +- Fix allocating large Views [\#4907](https://github.com/kokkos/kokkos/pull/4907) +- Fix bounds errors with Kokkos::sort [\#4980](https://github.com/kokkos/kokkos/pull/4980) +- Fix HIP version when printing the configuration [\#4872](https://github.com/kokkos/kokkos/pull/4872) +- Fixed `_CUDA_ARCH__` to `__CUDA_ARCH__` for CUDA LDG [\#4893](https://github.com/kokkos/kokkos/pull/4893) +- Fixed an incorrect struct initialization [\#5028](https://github.com/kokkos/kokkos/pull/5028) +- Fix racing condition in `HIPParallelLaunch` [\#5008](https://github.com/kokkos/kokkos/pull/5008) +- Avoid deprecation warnings with `OpenMPExec::validate_partition` [\#4982](https://github.com/kokkos/kokkos/pull/4982) +- Make View self-assignment not produce double-free [\#5024](https://github.com/kokkos/kokkos/pull/5024) + + ## [3.6.00](https://github.com/kokkos/kokkos/tree/3.6.00) (2022-02-18) [Full Changelog](https://github.com/kokkos/kokkos/compare/3.5.00...3.6.00) diff --git a/lib/kokkos/CMakeLists.txt b/lib/kokkos/CMakeLists.txt index e1c6893725..b0a54118a0 100644 --- a/lib/kokkos/CMakeLists.txt +++ b/lib/kokkos/CMakeLists.txt @@ -136,7 +136,7 @@ ENDIF() set(Kokkos_VERSION_MAJOR 3) set(Kokkos_VERSION_MINOR 6) -set(Kokkos_VERSION_PATCH 00) +set(Kokkos_VERSION_PATCH 01) set(Kokkos_VERSION "${Kokkos_VERSION_MAJOR}.${Kokkos_VERSION_MINOR}.${Kokkos_VERSION_PATCH}") math(EXPR KOKKOS_VERSION "${Kokkos_VERSION_MAJOR} * 10000 + ${Kokkos_VERSION_MINOR} * 100 + ${Kokkos_VERSION_PATCH}") diff --git a/lib/kokkos/Makefile.kokkos b/lib/kokkos/Makefile.kokkos index aa5f7c98f8..755831452b 100644 --- a/lib/kokkos/Makefile.kokkos +++ b/lib/kokkos/Makefile.kokkos @@ -12,7 +12,7 @@ endif KOKKOS_VERSION_MAJOR = 3 KOKKOS_VERSION_MINOR = 6 -KOKKOS_VERSION_PATCH = 00 +KOKKOS_VERSION_PATCH = 01 KOKKOS_VERSION = $(shell echo $(KOKKOS_VERSION_MAJOR)*10000+$(KOKKOS_VERSION_MINOR)*100+$(KOKKOS_VERSION_PATCH) | bc) # Options: Cuda,HIP,SYCL,OpenMPTarget,OpenMP,Threads,Serial diff --git a/lib/kokkos/algorithms/src/Kokkos_Sort.hpp b/lib/kokkos/algorithms/src/Kokkos_Sort.hpp index cde5e6857e..ce97de9b7d 100644 --- a/lib/kokkos/algorithms/src/Kokkos_Sort.hpp +++ b/lib/kokkos/algorithms/src/Kokkos_Sort.hpp @@ -422,54 +422,34 @@ class BinSort { template struct BinOp1D { - int max_bins_; - double mul_; - typename KeyViewType::const_value_type range_; - typename KeyViewType::const_value_type min_; + int max_bins_ = {}; + double mul_ = {}; + double min_ = {}; - BinOp1D() - : max_bins_(0), - mul_(0.0), - range_(typename KeyViewType::const_value_type()), - min_(typename KeyViewType::const_value_type()) {} + BinOp1D() = default; // Construct BinOp with number of bins, minimum value and maxuimum value BinOp1D(int max_bins__, typename KeyViewType::const_value_type min, typename KeyViewType::const_value_type max) : max_bins_(max_bins__ + 1), - // Cast to int64_t to avoid possible overflow when using integer - mul_(std::is_integral::value - ? 1.0 * max_bins__ / (int64_t(max) - int64_t(min)) - : 1.0 * max_bins__ / (max - min)), - range_(max - min), - min_(min) { + // Cast to double to avoid possible overflow when using integer + mul_(static_cast(max_bins__) / + (static_cast(max) - static_cast(min))), + min_(static_cast(min)) { // For integral types the number of bins may be larger than the range // in which case we can exactly have one unique value per bin // and then don't need to sort bins. if (std::is_integral::value && - static_cast(range_) <= static_cast(max_bins__)) { + (static_cast(max) - static_cast(min)) <= + static_cast(max_bins__)) { mul_ = 1.; } } // Determine bin index from key value - template < - class ViewType, - std::enable_if_t::value, - bool> = true> + template KOKKOS_INLINE_FUNCTION int bin(ViewType& keys, const int& i) const { - return int(mul_ * (keys(i) - min_)); - } - - // Determine bin index from key value - template < - class ViewType, - std::enable_if_t::value, - bool> = true> - KOKKOS_INLINE_FUNCTION int bin(ViewType& keys, const int& i) const { - // The cast to int64_t is necessary because otherwise HIP returns the wrong - // result. - return int(mul_ * (int64_t(keys(i)) - int64_t(min_))); + return static_cast(mul_ * (static_cast(keys(i)) - min_)); } // Return maximum bin index + 1 @@ -486,10 +466,9 @@ struct BinOp1D { template struct BinOp3D { - int max_bins_[3]; - double mul_[3]; - typename KeyViewType::non_const_value_type range_[3]; - typename KeyViewType::non_const_value_type min_[3]; + int max_bins_[3] = {}; + double mul_[3] = {}; + double min_[3] = {}; BinOp3D() = default; @@ -498,15 +477,15 @@ struct BinOp3D { max_bins_[0] = max_bins__[0]; max_bins_[1] = max_bins__[1]; max_bins_[2] = max_bins__[2]; - mul_[0] = 1.0 * max_bins__[0] / (max[0] - min[0]); - mul_[1] = 1.0 * max_bins__[1] / (max[1] - min[1]); - mul_[2] = 1.0 * max_bins__[2] / (max[2] - min[2]); - range_[0] = max[0] - min[0]; - range_[1] = max[1] - min[1]; - range_[2] = max[2] - min[2]; - min_[0] = min[0]; - min_[1] = min[1]; - min_[2] = min[2]; + mul_[0] = static_cast(max_bins__[0]) / + (static_cast(max[0]) - static_cast(min[0])); + mul_[1] = static_cast(max_bins__[1]) / + (static_cast(max[1]) - static_cast(min[1])); + mul_[2] = static_cast(max_bins__[2]) / + (static_cast(max[2]) - static_cast(min[2])); + min_[0] = static_cast(min[0]); + min_[1] = static_cast(min[1]); + min_[2] = static_cast(min[2]); } template @@ -596,9 +575,9 @@ std::enable_if_t::value> sort( // TODO: figure out better max_bins then this ... int64_t max_bins = view.extent(0) / 2; if (std::is_integral::value) { - // Cast to int64_t to avoid possible overflow when using integer - int64_t const max_val = result.max_val; - int64_t const min_val = result.min_val; + // Cast to double to avoid possible overflow when using integer + auto const max_val = static_cast(result.max_val); + auto const min_val = static_cast(result.min_val); // using 10M as the cutoff for special behavior (roughly 40MB for the count // array) if ((max_val - min_val) < 10000000) { @@ -606,6 +585,10 @@ std::enable_if_t::value> sort( sort_in_bins = false; } } + if (std::is_floating_point::value) { + KOKKOS_ASSERT(std::isfinite(static_cast(result.max_val) - + static_cast(result.min_val))); + } BinSort bin_sort( view, CompType(max_bins, result.min_val, result.max_val), sort_in_bins); diff --git a/lib/kokkos/algorithms/unit_tests/TestSort.hpp b/lib/kokkos/algorithms/unit_tests/TestSort.hpp index a03847f2b2..9108731c15 100644 --- a/lib/kokkos/algorithms/unit_tests/TestSort.hpp +++ b/lib/kokkos/algorithms/unit_tests/TestSort.hpp @@ -353,6 +353,55 @@ void test_issue_1160_impl() { } } +template +void test_issue_4978_impl() { + Kokkos::View element_("element", 9); + + auto h_element = Kokkos::create_mirror_view(element_); + + h_element(0) = LLONG_MIN; + h_element(1) = 0; + h_element(2) = 3; + h_element(3) = 2; + h_element(4) = 1; + h_element(5) = 3; + h_element(6) = 6; + h_element(7) = 4; + h_element(8) = 3; + + ExecutionSpace exec; + Kokkos::deep_copy(exec, element_, h_element); + + Kokkos::sort(exec, element_); + + Kokkos::deep_copy(exec, h_element, element_); + exec.fence(); + + ASSERT_EQ(h_element(0), LLONG_MIN); + ASSERT_EQ(h_element(1), 0); + ASSERT_EQ(h_element(2), 1); + ASSERT_EQ(h_element(3), 2); + ASSERT_EQ(h_element(4), 3); + ASSERT_EQ(h_element(5), 3); + ASSERT_EQ(h_element(6), 3); + ASSERT_EQ(h_element(7), 4); + ASSERT_EQ(h_element(8), 6); +} + +template +void test_sort_integer_overflow() { + // array with two extrema in reverse order to expose integer overflow bug in + // bin calculation + T a[2] = {Kokkos::Experimental::finite_max::value, + Kokkos::Experimental::finite_min::value}; + auto vd = Kokkos::create_mirror_view_and_copy( + ExecutionSpace(), Kokkos::View(a)); + Kokkos::sort(vd, /*force using Kokkos bin sort*/ true); + auto vh = Kokkos::create_mirror_view_and_copy(Kokkos::HostSpace(), vd); + EXPECT_TRUE(std::is_sorted(vh.data(), vh.data() + 2)) + << "view (" << vh[0] << ", " << vh[1] << ") is not sorted"; +} + //---------------------------------------------------------------------------- template @@ -376,6 +425,11 @@ void test_issue_1160_sort() { test_issue_1160_impl(); } +template +void test_issue_4978_sort() { + test_issue_4978_impl(); +} + template void test_sort(unsigned int N) { test_1D_sort(N); @@ -385,6 +439,10 @@ void test_sort(unsigned int N) { test_dynamic_view_sort(N); #endif test_issue_1160_sort(); + test_issue_4978_sort(); + test_sort_integer_overflow(); + test_sort_integer_overflow(); + test_sort_integer_overflow(); } } // namespace Impl } // namespace Test diff --git a/lib/kokkos/containers/src/Kokkos_ScatterView.hpp b/lib/kokkos/containers/src/Kokkos_ScatterView.hpp index 024b4618a4..e4dd9531fc 100644 --- a/lib/kokkos/containers/src/Kokkos_ScatterView.hpp +++ b/lib/kokkos/containers/src/Kokkos_ScatterView.hpp @@ -369,18 +369,6 @@ struct ScatterValue(&dest, dest_old, dest_new); - success = ((dest_new - dest_old) / dest_old <= 1e-15); - } - } - KOKKOS_INLINE_FUNCTION void join(ValueType& dest, const ValueType& src) const { atomic_prod(&dest, src); @@ -440,21 +428,9 @@ struct ScatterValue src) ? src : dest_old; - dest_new = - Kokkos::atomic_compare_exchange(&dest, dest_old, dest_new); - success = ((dest_new - dest_old) / dest_old <= 1e-15); - } - } - KOKKOS_INLINE_FUNCTION void join(ValueType& dest, const ValueType& src) const { - atomic_min(dest, src); + atomic_min(&dest, src); } KOKKOS_INLINE_FUNCTION @@ -511,21 +487,9 @@ struct ScatterValue(&dest, dest_old, dest_new); - success = ((dest_new - dest_old) / dest_old <= 1e-15); - } - } - KOKKOS_INLINE_FUNCTION void join(ValueType& dest, const ValueType& src) const { - atomic_max(dest, src); + atomic_max(&dest, src); } KOKKOS_INLINE_FUNCTION diff --git a/lib/kokkos/containers/src/Kokkos_Vector.hpp b/lib/kokkos/containers/src/Kokkos_Vector.hpp index 88721bd89e..eddb878003 100644 --- a/lib/kokkos/containers/src/Kokkos_Vector.hpp +++ b/lib/kokkos/containers/src/Kokkos_Vector.hpp @@ -162,7 +162,7 @@ class vector : public DualView { } DV::sync_host(); DV::modify_host(); - if (it < begin() || it > end()) + if (std::less<>()(it, begin()) || std::less<>()(end(), it)) Kokkos::abort("Kokkos::vector::insert : invalid insert iterator"); if (count == 0) return it; ptrdiff_t start = std::distance(begin(), it); @@ -189,27 +189,21 @@ class vector : public DualView { iterator>::type insert(iterator it, InputIterator b, InputIterator e) { ptrdiff_t count = std::distance(b, e); - if (count == 0) return it; DV::sync_host(); DV::modify_host(); - if (it < begin() || it > end()) + if (std::less<>()(it, begin()) || std::less<>()(end(), it)) Kokkos::abort("Kokkos::vector::insert : invalid insert iterator"); - bool resized = false; - if ((size() == 0) && (it == begin())) { - resize(count); - it = begin(); - resized = true; - } ptrdiff_t start = std::distance(begin(), it); auto org_size = size(); - if (!resized) resize(size() + count); - it = begin() + start; + + // Note: resize(...) invalidates it; use begin() + start instead + resize(size() + count); std::copy_backward(begin() + start, begin() + org_size, begin() + org_size + count); - std::copy(b, e, it); + std::copy(b, e, begin() + start); return begin() + start; } diff --git a/lib/kokkos/containers/unit_tests/TestVector.hpp b/lib/kokkos/containers/unit_tests/TestVector.hpp index 57b92c38f8..c093c7b0c9 100644 --- a/lib/kokkos/containers/unit_tests/TestVector.hpp +++ b/lib/kokkos/containers/unit_tests/TestVector.hpp @@ -172,6 +172,23 @@ struct test_vector_insert { run_test(a); check_test(a, size); } + { test_vector_insert_into_empty(size); } + } + + void test_vector_insert_into_empty(const size_t size) { + using Vector = Kokkos::vector; + { + Vector a; + Vector b(size); + a.insert(a.begin(), b.begin(), b.end()); + ASSERT_EQ(a.size(), size); + } + + { + Vector c; + c.insert(c.begin(), size, Scalar{}); + ASSERT_EQ(c.size(), size); + } } }; diff --git a/lib/kokkos/core/src/CMakeLists.txt b/lib/kokkos/core/src/CMakeLists.txt index 88cca93f3c..793e07a841 100644 --- a/lib/kokkos/core/src/CMakeLists.txt +++ b/lib/kokkos/core/src/CMakeLists.txt @@ -8,6 +8,7 @@ KOKKOS_INCLUDE_DIRECTORIES( INSTALL (DIRECTORY "${CMAKE_CURRENT_SOURCE_DIR}/" DESTINATION ${KOKKOS_HEADER_DIR} + FILES_MATCHING PATTERN desul/src EXCLUDE PATTERN "*.inc" PATTERN "*.inc_*" diff --git a/lib/kokkos/core/src/Cuda/Kokkos_Cuda_Instance.cpp b/lib/kokkos/core/src/Cuda/Kokkos_Cuda_Instance.cpp index 294be2774b..aaa9ea8ad4 100644 --- a/lib/kokkos/core/src/Cuda/Kokkos_Cuda_Instance.cpp +++ b/lib/kokkos/core/src/Cuda/Kokkos_Cuda_Instance.cpp @@ -1007,6 +1007,15 @@ void CudaSpaceInitializer::print_configuration(std::ostream &msg, } } // namespace Impl + +#ifdef KOKKOS_ENABLE_CXX14 +namespace Tools { +namespace Experimental { +constexpr DeviceType DeviceTypeTraits::id; +} +} // namespace Tools +#endif + } // namespace Kokkos #else diff --git a/lib/kokkos/core/src/Cuda/Kokkos_Cuda_View.hpp b/lib/kokkos/core/src/Cuda/Kokkos_Cuda_View.hpp index 61563a0100..dec6ef15e1 100644 --- a/lib/kokkos/core/src/Cuda/Kokkos_Cuda_View.hpp +++ b/lib/kokkos/core/src/Cuda/Kokkos_Cuda_View.hpp @@ -139,7 +139,7 @@ struct CudaLDGFetch { template KOKKOS_INLINE_FUNCTION ValueType operator[](const iType& i) const { -#if defined(__CUDA_ARCH__) && (350 <= _CUDA_ARCH__) +#if defined(__CUDA_ARCH__) && (350 <= __CUDA_ARCH__) AliasType v = __ldg(reinterpret_cast(&m_ptr[i])); return *(reinterpret_cast(&v)); #else diff --git a/lib/kokkos/core/src/HIP/Kokkos_HIP_Instance.cpp b/lib/kokkos/core/src/HIP/Kokkos_HIP_Instance.cpp index 4a6a3ba99e..a8a0496afe 100644 --- a/lib/kokkos/core/src/HIP/Kokkos_HIP_Instance.cpp +++ b/lib/kokkos/core/src/HIP/Kokkos_HIP_Instance.cpp @@ -132,7 +132,8 @@ void HIPInternal::print_configuration(std::ostream &s) const { s << "macro KOKKOS_ENABLE_HIP : defined" << '\n'; #if defined(HIP_VERSION) s << "macro HIP_VERSION = " << HIP_VERSION << " = version " - << HIP_VERSION / 100 << "." << HIP_VERSION % 100 << '\n'; + << HIP_VERSION_MAJOR << '.' << HIP_VERSION_MINOR << '.' << HIP_VERSION_PATCH + << '\n'; #endif for (int i = 0; i < dev_info.m_hipDevCount; ++i) { @@ -467,7 +468,6 @@ void HIPInternal::finalize() { } char *HIPInternal::get_next_driver(size_t driverTypeSize) const { - std::lock_guard const lock(m_mutexWorkArray); if (d_driverWorkArray == nullptr) { KOKKOS_IMPL_HIP_SAFE_CALL( hipHostMalloc(&d_driverWorkArray, diff --git a/lib/kokkos/core/src/HIP/Kokkos_HIP_KernelLaunch.hpp b/lib/kokkos/core/src/HIP/Kokkos_HIP_KernelLaunch.hpp index 384b7ffd67..70b979e00a 100644 --- a/lib/kokkos/core/src/HIP/Kokkos_HIP_KernelLaunch.hpp +++ b/lib/kokkos/core/src/HIP/Kokkos_HIP_KernelLaunch.hpp @@ -490,6 +490,8 @@ struct HIPParallelLaunch< KOKKOS_ENSURE_HIP_LOCK_ARRAYS_ON_DEVICE(); + std::lock_guard const lock(hip_instance->m_mutexWorkArray); + // Invoke the driver function on the device DriverType *d_driver = reinterpret_cast( hip_instance->get_next_driver(sizeof(DriverType))); diff --git a/lib/kokkos/core/src/HIP/Kokkos_HIP_Locks.cpp b/lib/kokkos/core/src/HIP/Kokkos_HIP_Locks.cpp index f334d93412..e9cfbf99f7 100644 --- a/lib/kokkos/core/src/HIP/Kokkos_HIP_Locks.cpp +++ b/lib/kokkos/core/src/HIP/Kokkos_HIP_Locks.cpp @@ -56,8 +56,7 @@ namespace Kokkos { #ifdef KOKKOS_ENABLE_HIP_RELOCATABLE_DEVICE_CODE namespace Impl { -__device__ __constant__ HIPLockArrays g_device_hip_lock_arrays = {nullptr, - nullptr, 0}; +__device__ __constant__ HIPLockArrays g_device_hip_lock_arrays = {nullptr, 0}; } #endif diff --git a/lib/kokkos/core/src/HIP/Kokkos_HIP_Space.cpp b/lib/kokkos/core/src/HIP/Kokkos_HIP_Space.cpp index 6ade677fa8..776b7c6abe 100644 --- a/lib/kokkos/core/src/HIP/Kokkos_HIP_Space.cpp +++ b/lib/kokkos/core/src/HIP/Kokkos_HIP_Space.cpp @@ -464,6 +464,15 @@ void HIPSpaceInitializer::print_configuration(std::ostream& msg, } } // namespace Impl + +#ifdef KOKKOS_ENABLE_CXX14 +namespace Tools { +namespace Experimental { +constexpr DeviceType DeviceTypeTraits::id; +} +} // namespace Tools +#endif + } // namespace Kokkos //============================================================================== diff --git a/lib/kokkos/core/src/HPX/Kokkos_HPX.cpp b/lib/kokkos/core/src/HPX/Kokkos_HPX.cpp index acf2224f02..623c7da025 100644 --- a/lib/kokkos/core/src/HPX/Kokkos_HPX.cpp +++ b/lib/kokkos/core/src/HPX/Kokkos_HPX.cpp @@ -199,6 +199,15 @@ void HPXSpaceInitializer::print_configuration(std::ostream &msg, } } // namespace Impl + +#ifdef KOKKOS_ENABLE_CXX14 +namespace Tools { +namespace Experimental { +constexpr DeviceType DeviceTypeTraits::id; +} +} // namespace Tools +#endif + } // namespace Kokkos #else diff --git a/lib/kokkos/core/src/Kokkos_Cuda.hpp b/lib/kokkos/core/src/Kokkos_Cuda.hpp index 6305a1fa5d..0063b1cd1e 100644 --- a/lib/kokkos/core/src/Kokkos_Cuda.hpp +++ b/lib/kokkos/core/src/Kokkos_Cuda.hpp @@ -260,6 +260,7 @@ template <> struct DeviceTypeTraits { /// \brief An ID to differentiate (for example) Serial from OpenMP in Tooling static constexpr DeviceType id = DeviceType::Cuda; + static int device_id(const Cuda& exec) { return exec.cuda_device(); } }; } // namespace Experimental } // namespace Tools diff --git a/lib/kokkos/core/src/Kokkos_HIP_Space.hpp b/lib/kokkos/core/src/Kokkos_HIP_Space.hpp index 1371d21d38..68869a6074 100644 --- a/lib/kokkos/core/src/Kokkos_HIP_Space.hpp +++ b/lib/kokkos/core/src/Kokkos_HIP_Space.hpp @@ -571,6 +571,9 @@ namespace Experimental { template <> struct DeviceTypeTraits { static constexpr DeviceType id = DeviceType::HIP; + static int device_id(const Kokkos::Experimental::HIP& exec) { + return exec.hip_device(); + } }; } // namespace Experimental } // namespace Tools diff --git a/lib/kokkos/core/src/Kokkos_HPX.hpp b/lib/kokkos/core/src/Kokkos_HPX.hpp index d2ae9c0ec2..9238ca30a7 100644 --- a/lib/kokkos/core/src/Kokkos_HPX.hpp +++ b/lib/kokkos/core/src/Kokkos_HPX.hpp @@ -500,6 +500,7 @@ namespace Experimental { template <> struct DeviceTypeTraits { static constexpr DeviceType id = DeviceType::HPX; + static int device_id(const Kokkos::Experimental::HPX &) { return 0; } }; } // namespace Experimental } // namespace Tools diff --git a/lib/kokkos/core/src/Kokkos_OpenMP.hpp b/lib/kokkos/core/src/Kokkos_OpenMP.hpp index 5d76e689f2..767e5b9324 100644 --- a/lib/kokkos/core/src/Kokkos_OpenMP.hpp +++ b/lib/kokkos/core/src/Kokkos_OpenMP.hpp @@ -179,6 +179,7 @@ namespace Experimental { template <> struct DeviceTypeTraits { static constexpr DeviceType id = DeviceType::OpenMP; + static int device_id(const OpenMP&) { return 0; } }; } // namespace Experimental } // namespace Tools diff --git a/lib/kokkos/core/src/Kokkos_OpenMPTarget.hpp b/lib/kokkos/core/src/Kokkos_OpenMPTarget.hpp index f394f32408..373dc3d9c7 100644 --- a/lib/kokkos/core/src/Kokkos_OpenMPTarget.hpp +++ b/lib/kokkos/core/src/Kokkos_OpenMPTarget.hpp @@ -130,6 +130,9 @@ template <> struct DeviceTypeTraits<::Kokkos::Experimental::OpenMPTarget> { static constexpr DeviceType id = ::Kokkos::Profiling::Experimental::DeviceType::OpenMPTarget; + static int device_id(const Kokkos::Experimental::OpenMPTarget&) { + return omp_get_default_device(); + } }; } // namespace Experimental } // namespace Tools diff --git a/lib/kokkos/core/src/Kokkos_SYCL.hpp b/lib/kokkos/core/src/Kokkos_SYCL.hpp index 02095ff7b3..e29093db32 100644 --- a/lib/kokkos/core/src/Kokkos_SYCL.hpp +++ b/lib/kokkos/core/src/Kokkos_SYCL.hpp @@ -182,6 +182,9 @@ template <> struct DeviceTypeTraits { /// \brief An ID to differentiate (for example) Serial from OpenMP in Tooling static constexpr DeviceType id = DeviceType::SYCL; + static int device_id(const Kokkos::Experimental::SYCL& exec) { + return exec.sycl_device(); + } }; } // namespace Experimental } // namespace Tools diff --git a/lib/kokkos/core/src/Kokkos_Serial.hpp b/lib/kokkos/core/src/Kokkos_Serial.hpp index 9aada48bf6..b2e524c374 100644 --- a/lib/kokkos/core/src/Kokkos_Serial.hpp +++ b/lib/kokkos/core/src/Kokkos_Serial.hpp @@ -226,6 +226,7 @@ namespace Experimental { template <> struct DeviceTypeTraits { static constexpr DeviceType id = DeviceType::Serial; + static int device_id(const Serial&) { return 0; } }; } // namespace Experimental } // namespace Tools diff --git a/lib/kokkos/core/src/Kokkos_Threads.hpp b/lib/kokkos/core/src/Kokkos_Threads.hpp index 45a2d0e326..5879209f12 100644 --- a/lib/kokkos/core/src/Kokkos_Threads.hpp +++ b/lib/kokkos/core/src/Kokkos_Threads.hpp @@ -175,6 +175,7 @@ namespace Experimental { template <> struct DeviceTypeTraits { static constexpr DeviceType id = DeviceType::Threads; + static int device_id(const Threads&) { return 0; } }; } // namespace Experimental } // namespace Tools diff --git a/lib/kokkos/core/src/OpenMP/Kokkos_OpenMP_Exec.cpp b/lib/kokkos/core/src/OpenMP/Kokkos_OpenMP_Exec.cpp index d2283d456f..66dbbacce9 100644 --- a/lib/kokkos/core/src/OpenMP/Kokkos_OpenMP_Exec.cpp +++ b/lib/kokkos/core/src/OpenMP/Kokkos_OpenMP_Exec.cpp @@ -67,8 +67,9 @@ __thread int t_openmp_hardware_id = 0; __thread Impl::OpenMPExec *t_openmp_instance = nullptr; #ifdef KOKKOS_ENABLE_DEPRECATED_CODE_3 -void OpenMPExec::validate_partition(const int nthreads, int &num_partitions, - int &partition_size) { +void OpenMPExec::validate_partition_impl(const int nthreads, + int &num_partitions, + int &partition_size) { if (nthreads == 1) { num_partitions = 1; partition_size = 1; @@ -506,6 +507,15 @@ void OpenMPSpaceInitializer::print_configuration(std::ostream &msg, } } // namespace Impl + +#ifdef KOKKOS_ENABLE_CXX14 +namespace Tools { +namespace Experimental { +constexpr DeviceType DeviceTypeTraits::id; +} +} // namespace Tools +#endif + } // namespace Kokkos #else diff --git a/lib/kokkos/core/src/OpenMP/Kokkos_OpenMP_Exec.hpp b/lib/kokkos/core/src/OpenMP/Kokkos_OpenMP_Exec.hpp index 2f647af77e..ede24d1094 100644 --- a/lib/kokkos/core/src/OpenMP/Kokkos_OpenMP_Exec.hpp +++ b/lib/kokkos/core/src/OpenMP/Kokkos_OpenMP_Exec.hpp @@ -93,7 +93,11 @@ class OpenMPExec { #ifdef KOKKOS_ENABLE_DEPRECATED_CODE_3 KOKKOS_DEPRECATED static void validate_partition(const int nthreads, int& num_partitions, - int& partition_size); + int& partition_size) { + validate_partition_impl(nthreads, num_partitions, partition_size); + } + static void validate_partition_impl(const int nthreads, int& num_partitions, + int& partition_size); #endif private: @@ -179,8 +183,8 @@ KOKKOS_DEPRECATED void OpenMP::partition_master(F const& f, int num_partitions, Exec* prev_instance = Impl::t_openmp_instance; - Exec::validate_partition(prev_instance->m_pool_size, num_partitions, - partition_size); + Exec::validate_partition_impl(prev_instance->m_pool_size, num_partitions, + partition_size); OpenMP::memory_space space; diff --git a/lib/kokkos/core/src/SYCL/Kokkos_SYCL_Instance.hpp b/lib/kokkos/core/src/SYCL/Kokkos_SYCL_Instance.hpp index 907e4e9efe..45aacd7258 100644 --- a/lib/kokkos/core/src/SYCL/Kokkos_SYCL_Instance.hpp +++ b/lib/kokkos/core/src/SYCL/Kokkos_SYCL_Instance.hpp @@ -72,7 +72,7 @@ class SYCLInternal { bool force_shrink = false); uint32_t impl_get_instance_id() const; - int m_syclDev = -1; + int m_syclDev = 0; size_t m_maxWorkgroupSize = 0; uint32_t m_maxConcurrency = 0; diff --git a/lib/kokkos/core/src/Threads/Kokkos_ThreadsExec.cpp b/lib/kokkos/core/src/Threads/Kokkos_ThreadsExec.cpp index 8a7c49871b..9682564ee0 100644 --- a/lib/kokkos/core/src/Threads/Kokkos_ThreadsExec.cpp +++ b/lib/kokkos/core/src/Threads/Kokkos_ThreadsExec.cpp @@ -399,27 +399,68 @@ bool ThreadsExec::wake() { //---------------------------------------------------------------------------- +void ThreadsExec::execute_resize_scratch_in_serial() { + const unsigned begin = s_threads_process.m_pool_base ? 1 : 0; + + auto deallocate_scratch_memory = [](ThreadsExec &exec) { + if (exec.m_scratch) { + using Record = + Kokkos::Impl::SharedAllocationRecord; + Record *const r = Record::get_record(exec.m_scratch); + exec.m_scratch = nullptr; + Record::decrement(r); + } + }; + if (s_threads_process.m_pool_base) { + for (unsigned i = s_thread_pool_size[0]; begin < i;) { + deallocate_scratch_memory(*s_threads_exec[--i]); + } + } + + s_current_function = &first_touch_allocate_thread_private_scratch; + s_current_function_arg = &s_threads_process; + + // Make sure function and arguments are written before activating threads. + memory_fence(); + + for (unsigned i = s_thread_pool_size[0]; begin < i;) { + ThreadsExec &th = *s_threads_exec[--i]; + + th.m_pool_state = ThreadsExec::Active; + + wait_yield(th.m_pool_state, ThreadsExec::Active); + } + + if (s_threads_process.m_pool_base) { + deallocate_scratch_memory(s_threads_process); + s_threads_process.m_pool_state = ThreadsExec::Active; + first_touch_allocate_thread_private_scratch(s_threads_process, nullptr); + s_threads_process.m_pool_state = ThreadsExec::Inactive; + } + + s_current_function_arg = nullptr; + s_current_function = nullptr; + + // Make sure function and arguments are cleared before proceeding. + memory_fence(); +} + +//---------------------------------------------------------------------------- + void *ThreadsExec::root_reduce_scratch() { return s_threads_process.reduce_memory(); } -void ThreadsExec::execute_resize_scratch(ThreadsExec &exec, const void *) { - using Record = Kokkos::Impl::SharedAllocationRecord; - - if (exec.m_scratch) { - Record *const r = Record::get_record(exec.m_scratch); - - exec.m_scratch = nullptr; - - Record::decrement(r); - } - +void ThreadsExec::first_touch_allocate_thread_private_scratch(ThreadsExec &exec, + const void *) { exec.m_scratch_reduce_end = s_threads_process.m_scratch_reduce_end; exec.m_scratch_thread_end = s_threads_process.m_scratch_thread_end; if (s_threads_process.m_scratch_thread_end) { // Allocate tracked memory: { + using Record = + Kokkos::Impl::SharedAllocationRecord; Record *const r = Record::allocate(Kokkos::HostSpace(), "Kokkos::thread_scratch", s_threads_process.m_scratch_thread_end); @@ -461,7 +502,7 @@ void *ThreadsExec::resize_scratch(size_t reduce_size, size_t thread_size) { s_threads_process.m_scratch_reduce_end = reduce_size; s_threads_process.m_scratch_thread_end = reduce_size + thread_size; - execute_resize_scratch(s_threads_process, nullptr); + execute_resize_scratch_in_serial(); s_threads_process.m_scratch = s_threads_exec[0]->m_scratch; } @@ -845,6 +886,15 @@ void ThreadsSpaceInitializer::print_configuration(std::ostream &msg, } } // namespace Impl + +#ifdef KOKKOS_ENABLE_CXX14 +namespace Tools { +namespace Experimental { +constexpr DeviceType DeviceTypeTraits::id; +} +} // namespace Tools +#endif + } /* namespace Kokkos */ //---------------------------------------------------------------------------- //---------------------------------------------------------------------------- diff --git a/lib/kokkos/core/src/Threads/Kokkos_ThreadsExec.hpp b/lib/kokkos/core/src/Threads/Kokkos_ThreadsExec.hpp index 561b1ce292..d17f417bbc 100644 --- a/lib/kokkos/core/src/Threads/Kokkos_ThreadsExec.hpp +++ b/lib/kokkos/core/src/Threads/Kokkos_ThreadsExec.hpp @@ -123,12 +123,15 @@ class ThreadsExec { static void global_unlock(); static void spawn(); - static void execute_resize_scratch(ThreadsExec &, const void *); + static void first_touch_allocate_thread_private_scratch(ThreadsExec &, + const void *); static void execute_sleep(ThreadsExec &, const void *); ThreadsExec(const ThreadsExec &); ThreadsExec &operator=(const ThreadsExec &); + static void execute_resize_scratch_in_serial(); + public: KOKKOS_INLINE_FUNCTION int pool_size() const { return m_pool_size; } KOKKOS_INLINE_FUNCTION int pool_rank() const { return m_pool_rank; } diff --git a/lib/kokkos/core/src/impl/Kokkos_Profiling_Interface.hpp b/lib/kokkos/core/src/impl/Kokkos_Profiling_Interface.hpp index 4e0e81405f..d526682056 100644 --- a/lib/kokkos/core/src/impl/Kokkos_Profiling_Interface.hpp +++ b/lib/kokkos/core/src/impl/Kokkos_Profiling_Interface.hpp @@ -118,11 +118,14 @@ template constexpr uint32_t device_id_root() { constexpr auto device_id = static_cast(DeviceTypeTraits::id); - return (device_id << num_instance_bits); + return (device_id << (num_instance_bits + num_device_bits)); } template inline uint32_t device_id(ExecutionSpace const& space) noexcept { - return device_id_root() + space.impl_instance_id(); + return device_id_root() + + (DeviceTypeTraits::device_id(space) + << num_instance_bits) + + space.impl_instance_id(); } } // namespace Experimental } // namespace Tools diff --git a/lib/kokkos/core/src/impl/Kokkos_Serial.cpp b/lib/kokkos/core/src/impl/Kokkos_Serial.cpp index c49e838d8f..e5917eb59d 100644 --- a/lib/kokkos/core/src/impl/Kokkos_Serial.cpp +++ b/lib/kokkos/core/src/impl/Kokkos_Serial.cpp @@ -233,6 +233,15 @@ void SerialSpaceInitializer::print_configuration(std::ostream& msg, } } // namespace Impl + +#ifdef KOKKOS_ENABLE_CXX14 +namespace Tools { +namespace Experimental { +constexpr DeviceType DeviceTypeTraits::id; +} +} // namespace Tools +#endif + } // namespace Kokkos #else diff --git a/lib/kokkos/core/src/impl/Kokkos_ViewMapping.hpp b/lib/kokkos/core/src/impl/Kokkos_ViewMapping.hpp index 09f7af0918..f606a39839 100644 --- a/lib/kokkos/core/src/impl/Kokkos_ViewMapping.hpp +++ b/lib/kokkos/core/src/impl/Kokkos_ViewMapping.hpp @@ -1005,15 +1005,15 @@ struct ViewOffset< /* Cardinality of the domain index space */ KOKKOS_INLINE_FUNCTION constexpr size_type size() const { - return m_dim.N0 * m_dim.N1 * m_dim.N2 * m_dim.N3 * m_dim.N4 * m_dim.N5 * - m_dim.N6 * m_dim.N7; + return size_type(m_dim.N0) * m_dim.N1 * m_dim.N2 * m_dim.N3 * m_dim.N4 * + m_dim.N5 * m_dim.N6 * m_dim.N7; } /* Span of the range space */ KOKKOS_INLINE_FUNCTION constexpr size_type span() const { - return m_dim.N0 * m_dim.N1 * m_dim.N2 * m_dim.N3 * m_dim.N4 * m_dim.N5 * - m_dim.N6 * m_dim.N7; + return size_type(m_dim.N0) * m_dim.N1 * m_dim.N2 * m_dim.N3 * m_dim.N4 * + m_dim.N5 * m_dim.N6 * m_dim.N7; } KOKKOS_INLINE_FUNCTION constexpr bool span_is_contiguous() const { @@ -1026,23 +1026,24 @@ struct ViewOffset< return m_dim.N0; } KOKKOS_INLINE_FUNCTION constexpr size_type stride_2() const { - return m_dim.N0 * m_dim.N1; + return size_type(m_dim.N0) * m_dim.N1; } KOKKOS_INLINE_FUNCTION constexpr size_type stride_3() const { - return m_dim.N0 * m_dim.N1 * m_dim.N2; + return size_type(m_dim.N0) * m_dim.N1 * m_dim.N2; } KOKKOS_INLINE_FUNCTION constexpr size_type stride_4() const { - return m_dim.N0 * m_dim.N1 * m_dim.N2 * m_dim.N3; + return size_type(m_dim.N0) * m_dim.N1 * m_dim.N2 * m_dim.N3; } KOKKOS_INLINE_FUNCTION constexpr size_type stride_5() const { - return m_dim.N0 * m_dim.N1 * m_dim.N2 * m_dim.N3 * m_dim.N4; + return size_type(m_dim.N0) * m_dim.N1 * m_dim.N2 * m_dim.N3 * m_dim.N4; } KOKKOS_INLINE_FUNCTION constexpr size_type stride_6() const { - return m_dim.N0 * m_dim.N1 * m_dim.N2 * m_dim.N3 * m_dim.N4 * m_dim.N5; + return size_type(m_dim.N0) * m_dim.N1 * m_dim.N2 * m_dim.N3 * m_dim.N4 * + m_dim.N5; } KOKKOS_INLINE_FUNCTION constexpr size_type stride_7() const { - return m_dim.N0 * m_dim.N1 * m_dim.N2 * m_dim.N3 * m_dim.N4 * m_dim.N5 * - m_dim.N6; + return size_type(m_dim.N0) * m_dim.N1 * m_dim.N2 * m_dim.N3 * m_dim.N4 * + m_dim.N5 * m_dim.N6; } // Stride with [ rank ] value is the total length @@ -1288,8 +1289,8 @@ struct ViewOffset< /* Cardinality of the domain index space */ KOKKOS_INLINE_FUNCTION constexpr size_type size() const { - return m_dim.N0 * m_dim.N1 * m_dim.N2 * m_dim.N3 * m_dim.N4 * m_dim.N5 * - m_dim.N6 * m_dim.N7; + return size_type(m_dim.N0) * m_dim.N1 * m_dim.N2 * m_dim.N3 * m_dim.N4 * + m_dim.N5 * m_dim.N6 * m_dim.N7; } /* Span of the range space */ @@ -1633,15 +1634,15 @@ struct ViewOffset< /* Cardinality of the domain index space */ KOKKOS_INLINE_FUNCTION constexpr size_type size() const { - return m_dim.N0 * m_dim.N1 * m_dim.N2 * m_dim.N3 * m_dim.N4 * m_dim.N5 * - m_dim.N6 * m_dim.N7; + return size_type(m_dim.N0) * m_dim.N1 * m_dim.N2 * m_dim.N3 * m_dim.N4 * + m_dim.N5 * m_dim.N6 * m_dim.N7; } /* Span of the range space */ KOKKOS_INLINE_FUNCTION constexpr size_type span() const { - return m_dim.N0 * m_dim.N1 * m_dim.N2 * m_dim.N3 * m_dim.N4 * m_dim.N5 * - m_dim.N6 * m_dim.N7; + return size_type(m_dim.N0) * m_dim.N1 * m_dim.N2 * m_dim.N3 * m_dim.N4 * + m_dim.N5 * m_dim.N6 * m_dim.N7; } KOKKOS_INLINE_FUNCTION constexpr bool span_is_contiguous() const { @@ -1916,14 +1917,14 @@ struct ViewOffset< /* Cardinality of the domain index space */ KOKKOS_INLINE_FUNCTION constexpr size_type size() const { - return m_dim.N0 * m_dim.N1 * m_dim.N2 * m_dim.N3 * m_dim.N4 * m_dim.N5 * - m_dim.N6 * m_dim.N7; + return size_type(m_dim.N0) * m_dim.N1 * m_dim.N2 * m_dim.N3 * m_dim.N4 * + m_dim.N5 * m_dim.N6 * m_dim.N7; } /* Span of the range space */ KOKKOS_INLINE_FUNCTION constexpr size_type span() const { - return size() > 0 ? m_dim.N0 * m_stride : 0; + return size() > 0 ? size_type(m_dim.N0) * m_stride : 0; } KOKKOS_INLINE_FUNCTION constexpr bool span_is_contiguous() const { @@ -2066,27 +2067,29 @@ struct ViewOffset< stride(/* 2 <= rank */ m_dim.N1 * (dimension_type::rank == 2 - ? 1 + ? size_t(1) : m_dim.N2 * (dimension_type::rank == 3 - ? 1 + ? size_t(1) : m_dim.N3 * (dimension_type::rank == 4 - ? 1 + ? size_t(1) : m_dim.N4 * (dimension_type::rank == 5 - ? 1 + ? size_t(1) : m_dim.N5 * (dimension_type:: rank == 6 - ? 1 + ? size_t( + 1) : m_dim.N6 * (dimension_type:: rank == 7 - ? 1 + ? size_t( + 1) : m_dim .N7)))))))) { } @@ -2447,8 +2450,8 @@ struct ViewOffset { constexpr size_type size() const { return dimension_type::rank == 0 ? 1 - : m_dim.N0 * m_dim.N1 * m_dim.N2 * m_dim.N3 * m_dim.N4 * - m_dim.N5 * m_dim.N6 * m_dim.N7; + : size_type(m_dim.N0) * m_dim.N1 * m_dim.N2 * m_dim.N3 * + m_dim.N4 * m_dim.N5 * m_dim.N6 * m_dim.N7; } private: diff --git a/lib/kokkos/core/src/impl/Kokkos_ViewTracker.hpp b/lib/kokkos/core/src/impl/Kokkos_ViewTracker.hpp index fe3651886b..972b1b6d9a 100644 --- a/lib/kokkos/core/src/impl/Kokkos_ViewTracker.hpp +++ b/lib/kokkos/core/src/impl/Kokkos_ViewTracker.hpp @@ -91,6 +91,7 @@ struct ViewTracker { template KOKKOS_INLINE_FUNCTION void assign(const View& vt) noexcept { + if (this == reinterpret_cast(&vt.m_track)) return; KOKKOS_IF_ON_HOST(( if (view_traits::is_managed && Kokkos::Impl::SharedAllocationRecord< void, void>::tracking_enabled()) { @@ -102,6 +103,7 @@ struct ViewTracker { KOKKOS_INLINE_FUNCTION ViewTracker& operator=( const ViewTracker& rhs) noexcept { + if (this == &rhs) return *this; KOKKOS_IF_ON_HOST(( if (view_traits::is_managed && Kokkos::Impl::SharedAllocationRecord< void, void>::tracking_enabled()) { diff --git a/lib/kokkos/core/unit_test/TestViewAPI.hpp b/lib/kokkos/core/unit_test/TestViewAPI.hpp index 21602be086..83efae6170 100644 --- a/lib/kokkos/core/unit_test/TestViewAPI.hpp +++ b/lib/kokkos/core/unit_test/TestViewAPI.hpp @@ -1087,6 +1087,20 @@ class TestViewAPI { dView4_unmanaged unmanaged_dx = dx; ASSERT_EQ(dx.use_count(), 1); + // Test self assignment +#if defined(__clang__) +#pragma GCC diagnostic push +#pragma GCC diagnostic ignored "-Wself-assign-overloaded" +#endif + dx = dx; // copy-assignment operator +#if defined(__clang__) +#pragma GCC diagnostic pop +#endif + ASSERT_EQ(dx.use_count(), 1); + dx = reinterpret_cast( + dx); // conversion assignment operator + ASSERT_EQ(dx.use_count(), 1); + dView4_unmanaged unmanaged_from_ptr_dx = dView4_unmanaged( dx.data(), dx.extent(0), dx.extent(1), dx.extent(2), dx.extent(3)); diff --git a/lib/kokkos/core/unit_test/TestViewAPI_e.hpp b/lib/kokkos/core/unit_test/TestViewAPI_e.hpp index d4f484a530..d1d38022a7 100644 --- a/lib/kokkos/core/unit_test/TestViewAPI_e.hpp +++ b/lib/kokkos/core/unit_test/TestViewAPI_e.hpp @@ -240,6 +240,35 @@ struct TestViewOverloadResolution { TEST(TEST_CATEGORY, view_overload_resolution) { TestViewOverloadResolution::test_function_overload(); } + +template +struct TestViewAllocationLargeRank { + using ViewType = Kokkos::View; + + KOKKOS_FUNCTION void operator()(int) const { + size_t idx = v.extent(0) - 1; + auto& lhs = v(idx, idx, idx, idx, idx, idx, idx, idx); + lhs = 42; // This is where it segfaulted + } + + ViewType v; +}; + +TEST(TEST_CATEGORY, view_allocation_large_rank) { + using ExecutionSpace = typename TEST_EXECSPACE::execution_space; + using MemorySpace = typename TEST_EXECSPACE::memory_space; + constexpr int dim = 16; + using FunctorType = TestViewAllocationLargeRank; + typename FunctorType::ViewType v("v", dim, dim, dim, dim, dim, dim, dim, dim); + + Kokkos::parallel_for(Kokkos::RangePolicy(0, 1), + FunctorType{v}); + typename FunctorType::ViewType v_single(v.data() + v.size() - 1, 1, 1, 1, 1, + 1, 1, 1, 1); + auto result = + Kokkos::create_mirror_view_and_copy(Kokkos::HostSpace{}, v_single); + ASSERT_EQ(result(0, 0, 0, 0, 0, 0, 0, 0), 42); +} } // namespace Test #include diff --git a/lib/kokkos/core/unit_test/tools/TestEventCorrectness.hpp b/lib/kokkos/core/unit_test/tools/TestEventCorrectness.hpp index 08863232ed..bb1d3156f5 100644 --- a/lib/kokkos/core/unit_test/tools/TestEventCorrectness.hpp +++ b/lib/kokkos/core/unit_test/tools/TestEventCorrectness.hpp @@ -238,13 +238,10 @@ TEST(kokkosp, test_id_gen) { using Kokkos::Tools::Experimental::DeviceTypeTraits; test_wrapper([&]() { Kokkos::DefaultExecutionSpace ex; - auto id = device_id(ex); - auto id_ref = identifier_from_devid(id); - auto success = (id_ref.instance_id == ex.impl_instance_id()) && - (id_ref.device_id == - static_cast( - DeviceTypeTraits::id)); - ASSERT_TRUE(success); + auto id = device_id(ex); + auto id_ref = identifier_from_devid(id); + ASSERT_EQ(DeviceTypeTraits::id, id_ref.type); + ASSERT_EQ(id_ref.instance_id, ex.impl_instance_id()); }); } @@ -253,6 +250,7 @@ TEST(kokkosp, test_id_gen) { */ TEST(kokkosp, test_kernel_sequence) { test_wrapper([&]() { + Kokkos::DefaultExecutionSpace ex; auto root = Kokkos::Tools::Experimental::device_id_root< Kokkos::DefaultExecutionSpace>(); std::vector expected{ @@ -260,11 +258,10 @@ TEST(kokkosp, test_kernel_sequence) { {"named_instance", FencePayload::distinguishable_devices::no, root + num_instances}, {"test_kernel", FencePayload::distinguishable_devices::no, - root + num_instances} + Kokkos::Tools::Experimental::device_id(ex)} }; expect_fence_events(expected, [=]() { - Kokkos::DefaultExecutionSpace ex; TestFunctor tf; ex.fence("named_instance"); Kokkos::parallel_for( diff --git a/lib/kokkos/master_history.txt b/lib/kokkos/master_history.txt index e174b47f67..41c755a8a8 100644 --- a/lib/kokkos/master_history.txt +++ b/lib/kokkos/master_history.txt @@ -27,3 +27,4 @@ tag: 3.4.00 date: 04:26:2021 master: 1fb0c284 release: 5d7738d6 tag: 3.4.01 date: 05:20:2021 master: 4b97a22f release: 410b15c8 tag: 3.5.00 date: 11:19:2021 master: c28a8b03 release: 21b879e4 tag: 3.6.00 date: 04:14:2022 master: 2834f94a release: 6ea708ff +tag: 3.6.01 date: 06:16:2022 master: b52f8c83 release: afe9b404 From 2d366ce2204c9b37ae69eb487085a3e7f695ee15 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Fri, 1 Jul 2022 14:08:46 -0600 Subject: [PATCH 504/585] add per-atom sp to extract() --- src/atom.cpp | 9 +++++++++ 1 file changed, 9 insertions(+) diff --git a/src/atom.cpp b/src/atom.cpp index 8b3ab8c75d..9aa9e00bce 100644 --- a/src/atom.cpp +++ b/src/atom.cpp @@ -2659,10 +2659,18 @@ void *Atom::extract(const char *name) if (strcmp(name,"body") == 0) return (void *) body; if (strcmp(name,"quat") == 0) return (void *) quat; + // PERI PACKAGE + if (strcmp(name,"vfrac") == 0) return (void *) vfrac; if (strcmp(name,"s0") == 0) return (void *) s0; if (strcmp(name,"x0") == 0) return (void *) x0; + // SPIN PACKAGE + + if (strcmp(name,"sp") == 0) return (void *) sp; + + // EFF and AWPMD packages + if (strcmp(name,"spin") == 0) return (void *) spin; if (strcmp(name,"eradius") == 0) return (void *) eradius; if (strcmp(name,"ervel") == 0) return (void *) ervel; @@ -2673,6 +2681,7 @@ void *Atom::extract(const char *name) if (strcmp(name,"vforce") == 0) return (void *) vforce; if (strcmp(name,"etag") == 0) return (void *) etag; + // SPH package if (strcmp(name,"rho") == 0) return (void *) rho; if (strcmp(name,"drho") == 0) return (void *) drho; if (strcmp(name,"esph") == 0) return (void *) esph; From cf49042fe6ce0d6a6dd3fac65c89c50be4c87e34 Mon Sep 17 00:00:00 2001 From: Stan Gerald Moore Date: Fri, 1 Jul 2022 14:13:08 -0600 Subject: [PATCH 505/585] Update Kokkos version in CMake --- cmake/Modules/Packages/KOKKOS.cmake | 6 +++--- 1 file changed, 3 insertions(+), 3 deletions(-) diff --git a/cmake/Modules/Packages/KOKKOS.cmake b/cmake/Modules/Packages/KOKKOS.cmake index cf3d19c720..7f23a6f777 100644 --- a/cmake/Modules/Packages/KOKKOS.cmake +++ b/cmake/Modules/Packages/KOKKOS.cmake @@ -47,8 +47,8 @@ if(DOWNLOAD_KOKKOS) list(APPEND KOKKOS_LIB_BUILD_ARGS "-DCMAKE_CXX_EXTENSIONS=${CMAKE_CXX_EXTENSIONS}") list(APPEND KOKKOS_LIB_BUILD_ARGS "-DCMAKE_TOOLCHAIN_FILE=${CMAKE_TOOLCHAIN_FILE}") include(ExternalProject) - set(KOKKOS_URL "https://github.com/kokkos/kokkos/archive/3.6.00.tar.gz" CACHE STRING "URL for KOKKOS tarball") - set(KOKKOS_MD5 "b5c44ea961031795f434002cd7b31c20" CACHE STRING "MD5 checksum of KOKKOS tarball") + set(KOKKOS_URL "https://github.com/kokkos/kokkos/archive/3.6.01.tar.gz" CACHE STRING "URL for KOKKOS tarball") + set(KOKKOS_MD5 "0ec97fc0c356dd65bd2487defe81a7bf" CACHE STRING "MD5 checksum of KOKKOS tarball") mark_as_advanced(KOKKOS_URL) mark_as_advanced(KOKKOS_MD5) ExternalProject_Add(kokkos_build @@ -72,7 +72,7 @@ if(DOWNLOAD_KOKKOS) add_dependencies(LAMMPS::KOKKOSCORE kokkos_build) add_dependencies(LAMMPS::KOKKOSCONTAINERS kokkos_build) elseif(EXTERNAL_KOKKOS) - find_package(Kokkos 3.6.00 REQUIRED CONFIG) + find_package(Kokkos 3.6.01 REQUIRED CONFIG) target_link_libraries(lammps PRIVATE Kokkos::kokkos) target_link_libraries(lmp PRIVATE Kokkos::kokkos) else() From dc1b7ba0a4195082f1540249679778346d9da644 Mon Sep 17 00:00:00 2001 From: rohskopf Date: Fri, 1 Jul 2022 15:37:00 -0600 Subject: [PATCH 506/585] Parallelization and ij pair collapse. --- examples/snap/compute_snap_dgrad.py | 21 ++- src/ML-SNAP/compute_snap.cpp | 198 ++++++++++++++-------------- src/ML-SNAP/compute_snap.h | 1 + 3 files changed, 118 insertions(+), 102 deletions(-) diff --git a/examples/snap/compute_snap_dgrad.py b/examples/snap/compute_snap_dgrad.py index 180734cb0c..95f2e1fa55 100644 --- a/examples/snap/compute_snap_dgrad.py +++ b/examples/snap/compute_snap_dgrad.py @@ -27,7 +27,7 @@ lmp = lammps(cmdargs = cmds) def run_lammps(dgradflag): # simulation settings - + lmp.command("clear") lmp.command("units metal") lmp.command("boundary p p p") @@ -40,7 +40,7 @@ def run_lammps(dgradflag): lmp.command("displace_atoms all random 0.01 0.01 0.01 123456") # potential settings - + snap_options = f'{rcutfac} {rfac0} {twojmax} {radelem1} {radelem2} {wj1} {wj2} rmin0 {rmin0} quadraticflag {quadratic} bzeroflag {bzero} switchflag {switch} bikflag {bikflag} dgradflag {dgradflag}' lmp.command(f"pair_style zero {rcutfac}") lmp.command(f"pair_coeff * *") @@ -111,6 +111,12 @@ run_lammps(dgradflag) lmp_snap = lmp.numpy.extract_compute("snap", LMP_STYLE_GLOBAL, LMP_TYPE_ARRAY) +# print snap array to observe +#if (me==0): +# np.savetxt("test_snap.dat", lmp_snap, fmt="%d %d %d %f %f %f %f %f") + +# take out rows with zero column + # extract dBj/dRi (includes dBi/dRi) natoms = lmp.get_natoms() @@ -120,6 +126,14 @@ dbdr_length = np.shape(lmp_snap)[0]-(natoms) - 1 dBdR = lmp_snap[natoms:(natoms+dbdr_length),3:(nd+3)] force_indices = lmp_snap[natoms:(natoms+dbdr_length),0:3].astype(np.int32) +# strip rows with all zero descriptor gradients to demonstrate how to save memory + +nonzero_rows = lmp_snap[natoms:(natoms+dbdr_length),3:(nd+3)] != 0.0 +nonzero_rows = np.any(nonzero_rows, axis=1) +dBdR = dBdR[nonzero_rows, :] +force_indices = force_indices[nonzero_rows,:] +dbdr_length = np.shape(dBdR)[0] + # sum over atoms i that j is a neighbor of, like dgradflag = 0 does. array1 = np.zeros((3*natoms,nd)) @@ -128,6 +142,7 @@ for k in range(0,nd): i = force_indices[l,0] j = force_indices[l,1] a = force_indices[l,2] + #print(f"{i} {j} {a}") array1[3 * j + a, k] += dBdR[l,k] # run lammps with dgradflag off @@ -135,7 +150,7 @@ for k in range(0,nd): if me == 0: print("Running with dgradflag off") -dgradflag = 0 +dgradflag = 0 run_lammps(dgradflag) # get global snap array diff --git a/src/ML-SNAP/compute_snap.cpp b/src/ML-SNAP/compute_snap.cpp index eb404d70a4..52c1b32fbc 100644 --- a/src/ML-SNAP/compute_snap.cpp +++ b/src/ML-SNAP/compute_snap.cpp @@ -190,7 +190,7 @@ ComputeSnap::ComputeSnap(LAMMPS *lmp, int narg, char **arg) : if (dgradflag && quadraticflag) error->all(FLERR,"Illegal compute snap command: dgradflag=1 not implemented for quadratic SNAP"); - + snaptr = new SNA(lmp, rfac0, twojmax, rmin0, switchflag, bzeroflag, chemflag, bnormflag, wselfallflag, @@ -372,6 +372,31 @@ void ComputeSnap::compute_array() const int typeoffset_local = ndims_peratom*nperdim*(itype-1); const int typeoffset_global = nperdim*(itype-1); + if (dgradflag){ + // dBi/dRi tags + snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 0][0] = atom->tag[i]-1; + snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 0][1] = atom->tag[i]-1; + snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 0][2] = 0; + snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 1][0] = atom->tag[i]-1; + snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 1][1] = atom->tag[i]-1; + snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 1][2] = 1; + snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 2][0] = atom->tag[i]-1; + snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 2][1] = atom->tag[i]-1; + snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 2][2] = 2; + // dBi/dRj tags + for (int j=0; jtag[i]-1) + 0][0] = atom->tag[i]-1; + snap[bik_rows + ((j)*3*natoms) + 3*(atom->tag[i]-1) + 0][1] = j; + snap[bik_rows + ((j)*3*natoms) + 3*(atom->tag[i]-1) + 0][2] = 0; + snap[bik_rows + ((j)*3*natoms) + 3*(atom->tag[i]-1) + 1][0] = atom->tag[i]-1; + snap[bik_rows + ((j)*3*natoms) + 3*(atom->tag[i]-1) + 1][1] = j; + snap[bik_rows + ((j)*3*natoms) + 3*(atom->tag[i]-1) + 1][2] = 1; + snap[bik_rows + ((j)*3*natoms) + 3*(atom->tag[i]-1) + 2][0] = atom->tag[i]-1; + snap[bik_rows + ((j)*3*natoms) + 3*(atom->tag[i]-1) + 2][1] = j; + snap[bik_rows + ((j)*3*natoms) + 3*(atom->tag[i]-1) + 2][2] = 2; + } + } + // insure rij, inside, and typej are of size jnum snaptr->grow_rij(jnum); @@ -459,13 +484,13 @@ void ComputeSnap::compute_array() double bix = snaptr->dblist[icoeff][0]; double biy = snaptr->dblist[icoeff][1]; double biz = snaptr->dblist[icoeff][2]; - + // diagonal elements of quadratic matrix - + double dbxtmp = bi*bix; double dbytmp = bi*biy; double dbztmp = bi*biz; - + snadi[ncount] += dbxtmp; snadi[ncount+yoffset] += dbytmp; snadi[ncount+zoffset] += dbztmp; @@ -476,7 +501,7 @@ void ComputeSnap::compute_array() ncount++; // upper-triangular elements of quadratic matrix - + for (int jcoeff = icoeff+1; jcoeff < ncoeff; jcoeff++) { double dbxtmp = bi*snaptr->dblist[jcoeff][0] + bix*snaptr->blist[jcoeff]; @@ -484,27 +509,27 @@ void ComputeSnap::compute_array() + biy*snaptr->blist[jcoeff]; double dbztmp = bi*snaptr->dblist[jcoeff][2] + biz*snaptr->blist[jcoeff]; - + snadi[ncount] += dbxtmp; snadi[ncount+yoffset] += dbytmp; snadi[ncount+zoffset] += dbztmp; snadj[ncount] -= dbxtmp; snadj[ncount+yoffset] -= dbytmp; snadj[ncount+zoffset] -= dbztmp; - + ncount++; } - + } } - + } else { for (int icoeff = 0; icoeff < ncoeff; icoeff++) { // sign convention same as compute snad - + /* dgrad[dgrad_row_indx+0][icoeff] = -snaptr->dblist[icoeff][0]; dgrad[dgrad_row_indx+1][icoeff] = -snaptr->dblist[icoeff][1]; dgrad[dgrad_row_indx+2][icoeff] = -snaptr->dblist[icoeff][2]; @@ -514,9 +539,20 @@ void ComputeSnap::compute_array() dbiri[3*(atom->tag[i]-1)+0][icoeff] += snaptr->dblist[icoeff][0]; dbiri[3*(atom->tag[i]-1)+1][icoeff] += snaptr->dblist[icoeff][1]; dbiri[3*(atom->tag[i]-1)+2][icoeff] += snaptr->dblist[icoeff][2]; - + */ + + // add to snap array for this proc + // dBi/dRj + snap[bik_rows + ((atom->tag[j]-1)*3*natoms) + 3*(atom->tag[i]-1) + 0][icoeff+3] -= snaptr->dblist[icoeff][0]; + snap[bik_rows + ((atom->tag[j]-1)*3*natoms) + 3*(atom->tag[i]-1) + 1][icoeff+3] -= snaptr->dblist[icoeff][1]; + snap[bik_rows + ((atom->tag[j]-1)*3*natoms) + 3*(atom->tag[i]-1) + 2][icoeff+3] -= snaptr->dblist[icoeff][2]; + // dBi/dRi + snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 0][icoeff+3] += snaptr->dblist[icoeff][0]; + snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 1][icoeff+3] += snaptr->dblist[icoeff][1]; + snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 2][icoeff+3] += snaptr->dblist[icoeff][2]; } + /* dgrad[dgrad_row_indx+0][ncoeff] = atom->tag[i]-1; dgrad[dgrad_row_indx+0][ncoeff+1] = atom->tag[j]-1; dgrad[dgrad_row_indx+0][ncoeff+2] = 0; @@ -530,20 +566,48 @@ void ComputeSnap::compute_array() dbiri[3*(atom->tag[i]-1)+0][ncoeff] = atom->tag[i]-1; dbiri[3*(atom->tag[i]-1)+0][ncoeff+1] = atom->tag[i]-1; dbiri[3*(atom->tag[i]-1)+0][ncoeff+2] = 0; - + dbiri[3*(atom->tag[i]-1)+1][ncoeff] = atom->tag[i]-1; dbiri[3*(atom->tag[i]-1)+1][ncoeff+1] = atom->tag[i]-1; dbiri[3*(atom->tag[i]-1)+1][ncoeff+2] = 1; - + dbiri[3*(atom->tag[i]-1)+2][ncoeff] = atom->tag[i]-1; dbiri[3*(atom->tag[i]-1)+2][ncoeff+1] = atom->tag[i]-1; dbiri[3*(atom->tag[i]-1)+2][ncoeff+2] = 2; + */ + + // add to snap array for this proc + // dBi/dRj tags + /* + snap[bik_rows + ((atom->tag[j]-1)*3*natoms) + 3*(atom->tag[i]-1) + 0][0] = atom->tag[i]-1; + snap[bik_rows + ((atom->tag[j]-1)*3*natoms) + 3*(atom->tag[i]-1) + 0][1] = atom->tag[j]-1; + snap[bik_rows + ((atom->tag[j]-1)*3*natoms) + 3*(atom->tag[i]-1) + 0][2] = 0; + snap[bik_rows + ((atom->tag[j]-1)*3*natoms) + 3*(atom->tag[i]-1) + 1][0] = atom->tag[i]-1; + snap[bik_rows + ((atom->tag[j]-1)*3*natoms) + 3*(atom->tag[i]-1) + 1][1] = atom->tag[j]-1; + snap[bik_rows + ((atom->tag[j]-1)*3*natoms) + 3*(atom->tag[i]-1) + 1][2] = 1; + snap[bik_rows + ((atom->tag[j]-1)*3*natoms) + 3*(atom->tag[i]-1) + 2][0] = atom->tag[i]-1; + snap[bik_rows + ((atom->tag[j]-1)*3*natoms) + 3*(atom->tag[i]-1) + 2][1] = atom->tag[j]-1; + snap[bik_rows + ((atom->tag[j]-1)*3*natoms) + 3*(atom->tag[i]-1) + 2][2] = 2; + */ + + // dBi/dRi tags + /* + snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 0][0] = atom->tag[i]-1; + snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 0][1] = atom->tag[i]-1; + snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 0][2] = 0; + snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 1][0] = atom->tag[i]-1; + snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 1][1] = atom->tag[i]-1; + snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 1][2] = 1; + snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 2][0] = atom->tag[i]-1; + snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 2][1] = atom->tag[i]-1; + snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 2][2] = 2; + */ } - } +} // loop over jj inside // accumulate Bi - + if (!dgradflag) { // linear contributions @@ -595,73 +659,6 @@ void ComputeSnap::compute_array() } else { - int irow = bik_rows; - for (int itype = 0; itype < 1; itype++) { - const int typeoffset_local = ndims_peratom * nperdim * itype; - const int typeoffset_global = nperdim * itype; - for (int i = 0; i < atom->nlocal; i++) { - - for (int jj = 0; jjtag[i]-1] + 3 * jj; - int snap_row_indx = 3 * neighsum[atom->tag[i]-1] + 3 * (atom->tag[i]-1) + 3 * jj; - // irow = snap_row_indx + bik_rows; - - // x-coordinate - for (int icoeff = 0; icoeff < nperdim; icoeff++) - snap[irow][icoeff+3] += dgrad[dgrad_row_indx+0][icoeff]; - snap[irow][0] += dgrad[dgrad_row_indx+0][ncoeff]; - snap[irow][0+1] += dgrad[dgrad_row_indx+0][ncoeff+1]; - snap[irow][0+2] += dgrad[dgrad_row_indx+0][ncoeff+2]; - irow++; - - // y-coordinate - for (int icoeff = 0; icoeff < nperdim; icoeff++) - snap[irow][icoeff+3] += dgrad[dgrad_row_indx+1][icoeff]; - snap[irow][0] += dgrad[dgrad_row_indx+1][ncoeff]; - snap[irow][0+1] += dgrad[dgrad_row_indx+1][ncoeff+1]; - snap[irow][0+2] += dgrad[dgrad_row_indx+1][ncoeff+2]; - irow++; - - // z-coordinate - for (int icoeff = 0; icoeff < nperdim; icoeff++) - snap[irow][icoeff+3] += dgrad[dgrad_row_indx+2][icoeff]; - snap[irow][0] += dgrad[dgrad_row_indx+2][ncoeff]; - snap[irow][0+1] += dgrad[dgrad_row_indx+2][ncoeff+1]; - snap[irow][0+2] += dgrad[dgrad_row_indx+2][ncoeff+2]; - irow++; - - } - - // Put dBi/dRi at end of each dBj/dRi chunk. - - // x-coordinate - for (int icoeff = 0; icoeff < nperdim; icoeff++) - snap[irow][icoeff+3] += dbiri[3*i+0][icoeff]; - snap[irow][0] += dbiri[3*i+0][ncoeff]; - snap[irow][0+1] += dbiri[3*i+0][ncoeff+1]; - snap[irow][0+2] += dbiri[3*i+0][ncoeff+2]; - irow++; - - // y-coordinate - for (int icoeff = 0; icoeff < nperdim; icoeff++) - snap[irow][icoeff+3] += dbiri[3*i+1][icoeff]; - snap[irow][0] += dbiri[3*i+1][ncoeff]; - snap[irow][0+1] += dbiri[3*i+1][ncoeff+1]; - snap[irow][0+2] += dbiri[3*i+1][ncoeff+2]; - irow++; - - // z-coordinate - for (int icoeff = 0; icoeff < nperdim; icoeff++) - snap[irow][icoeff+3] += dbiri[3*i+2][icoeff]; - snap[irow][0] += dbiri[3*i+2][ncoeff]; - snap[irow][0+1] += dbiri[3*i+2][ncoeff+1]; - snap[irow][0+2] += dbiri[3*i+2][ncoeff+2]; - irow++; - - } - } - } // accumulate forces to global array @@ -674,11 +671,11 @@ void ComputeSnap::compute_array() snap[irow++][lastcol] = atom->f[i][1]; snap[irow][lastcol] = atom->f[i][2]; } - + } else { - + // for dgradflag=1, put forces at first 3 columns of bik rows - + for (int i=0; inlocal; i++){ int iglobal = atom->tag[i]; snap[iglobal-1][0+0] = atom->f[i][0]; @@ -692,7 +689,7 @@ void ComputeSnap::compute_array() dbdotr_compute(); // sum up over all processes - + MPI_Allreduce(&snap[0][0],&snapall[0][0],size_array_rows*size_array_cols,MPI_DOUBLE,MPI_SUM,world); // assign energy to last column @@ -707,7 +704,8 @@ void ComputeSnap::compute_array() // Assign reference energy right after the dgrad rows, first column. // Add 3N for the dBi/dRi rows. - int irow = bik_rows + dgrad_rows + 3*natoms; + //int irow = bik_rows + dgrad_rows + 3*natoms; + int irow = bik_rows + 3*natoms*natoms; double reference_energy = c_pe->compute_scalar(); snapall[irow][0] = reference_energy; } @@ -725,7 +723,7 @@ void ComputeSnap::compute_array() snapall[irow++][lastcol] = c_virial->vector[4]; snapall[irow][lastcol] = c_virial->vector[3]; } - + } /* ---------------------------------------------------------------------- @@ -739,7 +737,7 @@ void ComputeSnap::dbdotr_compute() // no virial terms for dgrad yet if (dgradflag) return; - + double **x = atom->x; int irow0 = bik_rows+ndims_force*natoms; @@ -775,7 +773,7 @@ void ComputeSnap::dbdotr_compute() void ComputeSnap::get_dgrad_length() { - int rank = universe->me; // for MPI debugging + rank = universe->me; // for MPI debugging memory->destroy(snap); memory->destroy(snapall); @@ -796,8 +794,8 @@ void ComputeSnap::get_dgrad_length() memory->create(nneighs, natoms, "snap:nneighs"); memory->create(icounter, natoms, "snap:icounter"); memory->create(dbiri, 3*natoms,ncoeff+3, "snap:dbiri"); - if (atom->nlocal != natoms) - error->all(FLERR,"Compute snap dgradflag=1 does not support parallelism yet."); + //if (atom->nlocal != natoms) + // error->all(FLERR,"Compute snap dgradflag=1 does not support parallelism yet."); for (int ii = 0; ii < 3 * natoms; ii++) for (int icoeff = 0; icoeff < ncoeff; icoeff++) @@ -834,21 +832,23 @@ void ComputeSnap::get_dgrad_length() dgrad_rows *= ndims_force; - neighsum[0] = 0; + neighsum[0] = 0; for (int ii = 1; ii < inum; ii++) { const int i = ilist[ii]; if (mask[i] & groupbit) neighsum[i] = neighsum[i-1] + nneighs[i-1]; } - + memory->create(dgrad, dgrad_rows, ncoeff+3, "snap:dgrad"); for (int i = 0; i < dgrad_rows; i++) for (int j = 0; j < ncoeff+3; j++) dgrad[i][j] = 0.0; - + // set size array rows which now depends on dgrad_rows. - size_array_rows = bik_rows + dgrad_rows + 3*atom->nlocal + 1; // Add 3*N for dBi/dRi. and add 1 for reference energy + //size_array_rows = bik_rows + dgrad_rows + 3*atom->nlocal + 1; // Add 3*N for dBi/dRi. and add 1 for reference energy + size_array_rows = bik_rows + 3*natoms*natoms + 1; + //printf("----- dgrad_rows, 3*natoms*natoms: %d %d\n", dgrad_rows, 3*natoms*natoms); memory->create(snap,size_array_rows,size_array_cols, "snap:snap"); memory->create(snapall,size_array_rows,size_array_cols, "snap:snapall"); @@ -932,18 +932,18 @@ void ComputeSnap::get_dgrad_length2() // } // } - neighsum[0] = 0; + neighsum[0] = 0; for (int ii = 1; ii < inum; ii++) { const int i = ilist[ii]; if (mask[i] & groupbit) neighsum[i] = neighsum[i-1] + nneighs[i-1]; } - + memory->create(dgrad, dgrad_rows, ncoeff+3, "snap:dgrad"); for (int i = 0; i < dgrad_rows; i++) for (int j = 0; j < ncoeff+3; j++) dgrad[i][j] = 0.0; - + // set size array rows which now depends on dgrad_rows. size_array_rows = bik_rows + dgrad_rows + 3*atom->nlocal + 1; // Add 3*N for dBi/dRi. and add 1 for reference energy diff --git a/src/ML-SNAP/compute_snap.h b/src/ML-SNAP/compute_snap.h index f106421635..e1fb7cee49 100644 --- a/src/ML-SNAP/compute_snap.h +++ b/src/ML-SNAP/compute_snap.h @@ -59,6 +59,7 @@ class ComputeSnap : public Compute { int *nneighs; // number of neighs inside the snap cutoff. int *neighsum; int *icounter; // counting atoms i for each j. + int rank; Compute *c_pe; Compute *c_virial; From 4012897bffb9772c50fcbf530188baabde6fcbf8 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 1 Jul 2022 21:16:07 -0400 Subject: [PATCH 507/585] whitespace fixes and clang-format --- doc/src/package.rst | 2 +- src/KOKKOS/meam_dens_final_kokkos.h | 36 ++-- src/KOKKOS/meam_force_kokkos.h | 297 +++++++++++++++------------- src/KOKKOS/meam_kokkos.h | 189 ++++++++++-------- 4 files changed, 288 insertions(+), 236 deletions(-) diff --git a/doc/src/package.rst b/doc/src/package.rst index 6ff34515cf..0810bd5b6b 100644 --- a/doc/src/package.rst +++ b/doc/src/package.rst @@ -528,7 +528,7 @@ For the *comm/pair/forward* or *comm/fix/forward* or *comm/pair/reverse* keywords, if a value of *host* is used it will be automatically be changed to *no* since these keywords don't support *host* mode. The value of *no* will also always be used when running on the CPU, i.e. setting -the value to *device* will have no effect if the pair/fix style is +the value to *device* will have no effect if the pair/fix style is running on the CPU. For the *comm/fix/forward* or *comm/pair/reverse* keywords, not all styles support *device* mode and in that case will run in *no* mode instead. diff --git a/src/KOKKOS/meam_dens_final_kokkos.h b/src/KOKKOS/meam_dens_final_kokkos.h index aede2cbcc7..5d1c9926b7 100644 --- a/src/KOKKOS/meam_dens_final_kokkos.h +++ b/src/KOKKOS/meam_dens_final_kokkos.h @@ -74,17 +74,17 @@ void MEAMKokkos::operator()(TagMEAMDensFinal, const int &i, EV_FLOAT if (d_rho0[i] > 0.0) { if (ialloy == 1) { - d_t_ave(i,0) = fdiv_zero_kk(d_t_ave(i,0), d_tsq_ave(i,0)); - d_t_ave(i,1) = fdiv_zero_kk(d_t_ave(i,1), d_tsq_ave(i,1)); - d_t_ave(i,2) = fdiv_zero_kk(d_t_ave(i,2), d_tsq_ave(i,2)); + d_t_ave(i,0) = fdiv_zero_kk(d_t_ave(i,0), d_tsq_ave(i,0)); + d_t_ave(i,1) = fdiv_zero_kk(d_t_ave(i,1), d_tsq_ave(i,1)); + d_t_ave(i,2) = fdiv_zero_kk(d_t_ave(i,2), d_tsq_ave(i,2)); } else if (ialloy == 2) { - d_t_ave(i,0) = t1_meam[elti]; - d_t_ave(i,1) = t2_meam[elti]; - d_t_ave(i,2) = t3_meam[elti]; + d_t_ave(i,0) = t1_meam[elti]; + d_t_ave(i,1) = t2_meam[elti]; + d_t_ave(i,2) = t3_meam[elti]; } else { - d_t_ave(i,0) /= d_rho0[i]; - d_t_ave(i,1) /= d_rho0[i]; - d_t_ave(i,2) /= d_rho0[i]; + d_t_ave(i,0) /= d_rho0[i]; + d_t_ave(i,1) /= d_rho0[i]; + d_t_ave(i,2) /= d_rho0[i]; } } @@ -105,28 +105,28 @@ void MEAMKokkos::operator()(TagMEAMDensFinal, const int &i, EV_FLOAT dGbar = 0.0; } else { if (mix_ref_t == 1) - gam = (d_t_ave(i,0) * shp[0] + d_t_ave(i,1) * shp[1] + d_t_ave(i,2) * shp[2]) / (Z * Z); + gam = (d_t_ave(i,0) * shp[0] + d_t_ave(i,1) * shp[1] + d_t_ave(i,2) * shp[2]) / (Z * Z); else - gam = (t1_meam[elti] * shp[0] + t2_meam[elti] * shp[1] + t3_meam[elti] * shp[2]) / - (Z * Z); + gam = (t1_meam[elti] * shp[0] + t2_meam[elti] * shp[1] + t3_meam[elti] * shp[2]) / + (Z * Z); Gbar = G_gam(gam, ibar_meam[elti], d_errorflag()); } d_rho[i] = d_rho0[i] * G; if (mix_ref_t == 1) { if (ibar_meam[elti] <= 0) { - Gbar = 1.0; - dGbar = 0.0; + Gbar = 1.0; + dGbar = 0.0; } else { - gam = (d_t_ave(i,0) * shp[0] + d_t_ave(i,1) * shp[1] + d_t_ave(i,2) * shp[2]) / (Z * Z); - Gbar = dG_gam(gam, ibar_meam[elti], dGbar); + gam = (d_t_ave(i,0) * shp[0] + d_t_ave(i,1) * shp[1] + d_t_ave(i,2) * shp[2]) / (Z * Z); + Gbar = dG_gam(gam, ibar_meam[elti], dGbar); } rho_bkgd = rho0_meam[elti] * Z * Gbar; } else { if (bkgd_dyn == 1) - rho_bkgd = rho0_meam[elti] * Z; + rho_bkgd = rho0_meam[elti] * Z; else - rho_bkgd = rho_ref_meam[elti]; + rho_bkgd = rho_ref_meam[elti]; } rhob = d_rho[i] / rho_bkgd; denom = 1.0 / rho_bkgd; diff --git a/src/KOKKOS/meam_force_kokkos.h b/src/KOKKOS/meam_force_kokkos.h index aafcf80473..e7e6c64231 100644 --- a/src/KOKKOS/meam_force_kokkos.h +++ b/src/KOKKOS/meam_force_kokkos.h @@ -1,15 +1,19 @@ -#include "meam_kokkos.h" #include "math_special_kokkos.h" +#include "meam_kokkos.h" #include using namespace LAMMPS_NS; using namespace MathSpecialKokkos; -template -void -MEAMKokkos::meam_force(int inum_half, int eflag_global, int eflag_atom, int vflag_global, int vflag_atom, - typename ArrayTypes::t_efloat_1d eatom, int ntype, typename AT::t_int_1d type, typename AT::t_int_1d d_map, typename AT::t_x_array x, typename AT::t_int_1d numneigh, - typename AT::t_int_1d numneigh_full, typename AT::t_f_array f, typename ArrayTypes::t_virial_array vatom, typename AT::t_int_1d d_ilist_half, typename AT::t_int_1d d_offset, typename AT::t_neighbors_2d d_neighbors_half, typename AT::t_neighbors_2d d_neighbors_full, int neighflag, int need_dup, EV_FLOAT &ev_all) +template +void MEAMKokkos::meam_force( + int inum_half, int eflag_global, int eflag_atom, int vflag_global, int vflag_atom, + typename ArrayTypes::t_efloat_1d eatom, int ntype, typename AT::t_int_1d type, + typename AT::t_int_1d d_map, typename AT::t_x_array x, typename AT::t_int_1d numneigh, + typename AT::t_int_1d numneigh_full, typename AT::t_f_array f, + typename ArrayTypes::t_virial_array vatom, typename AT::t_int_1d d_ilist_half, + typename AT::t_int_1d d_offset, typename AT::t_neighbors_2d d_neighbors_half, + typename AT::t_neighbors_2d d_neighbors_full, int neighflag, int need_dup, EV_FLOAT &ev_all) { EV_FLOAT ev; @@ -35,20 +39,33 @@ MEAMKokkos::meam_force(int inum_half, int eflag_global, int eflag_at this->d_offset = d_offset; if (need_dup) { - dup_f = Kokkos::Experimental::create_scatter_view(f); - if (eflag_atom) dup_eatom = Kokkos::Experimental::create_scatter_view(d_eatom); - if (vflag_atom) dup_vatom = Kokkos::Experimental::create_scatter_view(d_vatom); + dup_f = Kokkos::Experimental::create_scatter_view(f); + if (eflag_atom) + dup_eatom = Kokkos::Experimental::create_scatter_view< + Kokkos::Experimental::ScatterSum, Kokkos::Experimental::ScatterDuplicated>(d_eatom); + if (vflag_atom) + dup_vatom = Kokkos::Experimental::create_scatter_view< + Kokkos::Experimental::ScatterSum, Kokkos::Experimental::ScatterDuplicated>(d_vatom); } else { - ndup_f = Kokkos::Experimental::create_scatter_view(f); - if (eflag_atom) ndup_eatom = Kokkos::Experimental::create_scatter_view(d_eatom); - if (vflag_atom) ndup_vatom = Kokkos::Experimental::create_scatter_view(d_vatom); + ndup_f = + Kokkos::Experimental::create_scatter_view(f); + if (eflag_atom) + ndup_eatom = Kokkos::Experimental::create_scatter_view< + Kokkos::Experimental::ScatterSum, Kokkos::Experimental::ScatterNonDuplicated>(d_eatom); + if (vflag_atom) + ndup_vatom = Kokkos::Experimental::create_scatter_view< + Kokkos::Experimental::ScatterSum, Kokkos::Experimental::ScatterNonDuplicated>(d_vatom); } copymode = 1; if (neighflag == HALF) - Kokkos::parallel_reduce(Kokkos::RangePolicy>(0,inum_half),*this,ev); + Kokkos::parallel_reduce(Kokkos::RangePolicy>(0, inum_half), + *this, ev); else if (neighflag == HALFTHREAD) - Kokkos::parallel_reduce(Kokkos::RangePolicy>(0,inum_half),*this,ev); + Kokkos::parallel_reduce(Kokkos::RangePolicy>(0, inum_half), + *this, ev); ev_all += ev; copymode = 0; @@ -64,11 +81,11 @@ MEAMKokkos::meam_force(int inum_half, int eflag_global, int eflag_at } } -template -template -KOKKOS_INLINE_FUNCTION -void -MEAMKokkos::operator()(TagMEAMForce, const int &ii, EV_FLOAT& ev) const { +template +template +KOKKOS_INLINE_FUNCTION void MEAMKokkos::operator()(TagMEAMForce, + const int &ii, EV_FLOAT &ev) const +{ int i, j, jn, k, kn, kk, m, n, p, q; int nv2, nv3, elti, eltj, eltk, ind; X_FLOAT xitmp, yitmp, zitmp, delij[3]; @@ -105,12 +122,16 @@ MEAMKokkos::operator()(TagMEAMForce, const int &ii, EV_FL // The f, etc. arrays are duplicated for OpenMP, atomic for CUDA, and neither for Serial - auto v_f = ScatterViewHelper,decltype(dup_f),decltype(ndup_f)>::get(dup_f,ndup_f); - auto a_f = v_f.template access>(); - auto v_eatom = ScatterViewHelper,decltype(dup_eatom),decltype(ndup_eatom)>::get(dup_eatom,ndup_eatom); - auto a_eatom = v_eatom.template access>(); - auto v_vatom = ScatterViewHelper,decltype(dup_vatom),decltype(ndup_vatom)>::get(dup_vatom,ndup_vatom); - auto a_vatom = v_vatom.template access>(); + auto v_f = + ScatterViewHelper, decltype(dup_f), decltype(ndup_f)>::get( + dup_f, ndup_f); + auto a_f = v_f.template access>(); + auto v_eatom = ScatterViewHelper, decltype(dup_eatom), + decltype(ndup_eatom)>::get(dup_eatom, ndup_eatom); + auto a_eatom = v_eatom.template access>(); + auto v_vatom = ScatterViewHelper, decltype(dup_vatom), + decltype(ndup_vatom)>::get(dup_vatom, ndup_vatom); + auto a_vatom = v_vatom.template access>(); i = d_ilist_half[ii]; fnoffset = d_offset[i]; @@ -120,21 +141,21 @@ MEAMKokkos::operator()(TagMEAMForce, const int &ii, EV_FL elti = d_map[type[i]]; if (elti < 0) return; - xitmp = x(i,0); - yitmp = x(i,1); - zitmp = x(i,2); + xitmp = x(i, 0); + yitmp = x(i, 1); + zitmp = x(i, 2); // Treat each pair for (jn = 0; jn < d_numneigh_half[i]; jn++) { - j = d_neighbors_half(i,jn); + j = d_neighbors_half(i, jn); eltj = d_map[type[j]]; if (!iszero_kk(d_scrfcn[fnoffset + jn]) && eltj >= 0) { sij = d_scrfcn[fnoffset + jn] * d_fcpair[fnoffset + jn]; - delij[0] = x(j,0) - xitmp; - delij[1] = x(j,1) - yitmp; - delij[2] = x(j,2) - zitmp; + delij[0] = x(j, 0) - xitmp; + delij[1] = x(j, 1) - yitmp; + delij[2] = x(j, 2) - zitmp; rij2 = delij[0] * delij[0] + delij[1] * delij[1] + delij[2] * delij[2]; if (rij2 < cutforcesq) { rij = sqrt(rij2); @@ -143,19 +164,18 @@ MEAMKokkos::operator()(TagMEAMForce, const int &ii, EV_FL // Compute phi and phip ind = eltind[elti][eltj]; pp = rij * rdrar; - kk = (int)pp; - kk = (kk <= (nrar - 2))?kk:nrar - 2; + kk = (int) pp; + kk = (kk <= (nrar - 2)) ? kk : nrar - 2; pp = pp - kk; - pp = (pp <= 1.0)?pp:1.0; - phi = ((d_phirar3(ind,kk) * pp + d_phirar2(ind,kk)) * pp + d_phirar1(ind,kk)) * pp + - d_phirar(ind,kk); - phip = (d_phirar6(ind,kk) * pp + d_phirar5(ind,kk)) * pp + d_phirar4(ind,kk); + pp = (pp <= 1.0) ? pp : 1.0; + phi = ((d_phirar3(ind, kk) * pp + d_phirar2(ind, kk)) * pp + d_phirar1(ind, kk)) * pp + + d_phirar(ind, kk); + phip = (d_phirar6(ind, kk) * pp + d_phirar5(ind, kk)) * pp + d_phirar4(ind, kk); if (eflag_either) { - double scaleij = d_scale(type[i],type[i]); + double scaleij = d_scale(type[i], type[i]); double phi_sc = phi * scaleij; - if (eflag_global) - ev.evdwl += phi_sc * sij; + if (eflag_global) ev.evdwl += phi_sc * sij; if (eflag_atom) { a_eatom[i] += 0.5 * phi * sij; a_eatom[j] += 0.5 * phi * sij; @@ -209,12 +229,12 @@ MEAMKokkos::operator()(TagMEAMForce, const int &ii, EV_FL const double t3mj = t3_meam[eltj]; if (ialloy == 1) { - rhoa1j *= t1mj; - rhoa2j *= t2mj; - rhoa3j *= t3mj; - rhoa1i *= t1mi; - rhoa2i *= t2mi; - rhoa3i *= t3mi; + rhoa1j *= t1mj; + rhoa2j *= t2mj; + rhoa3j *= t3mj; + rhoa1i *= t1mi; + rhoa2i *= t2mi; + rhoa3i *= t3mi; drhoa1j *= t1mj; drhoa2j *= t2mj; drhoa3j *= t3mj; @@ -237,19 +257,19 @@ MEAMKokkos::operator()(TagMEAMForce, const int &ii, EV_FL for (p = n; p < 3; p++) { for (q = p; q < 3; q++) { arg = delij[n] * delij[p] * delij[q] * v3D[nv3]; - arg1i3 = arg1i3 + d_arho3(i,nv3) * arg; - arg1j3 = arg1j3 - d_arho3(j,nv3) * arg; + arg1i3 = arg1i3 + d_arho3(i, nv3) * arg; + arg1j3 = arg1j3 - d_arho3(j, nv3) * arg; nv3 = nv3 + 1; } arg = delij[n] * delij[p] * v2D[nv2]; - arg1i2 = arg1i2 + d_arho2(i,nv2) * arg; - arg1j2 = arg1j2 + d_arho2(j,nv2) * arg; + arg1i2 = arg1i2 + d_arho2(i, nv2) * arg; + arg1j2 = arg1j2 + d_arho2(j, nv2) * arg; nv2 = nv2 + 1; } - arg1i1 = arg1i1 + d_arho1(i,n) * delij[n]; - arg1j1 = arg1j1 - d_arho1(j,n) * delij[n]; - arg3i3 = arg3i3 + d_arho3b(i,n) * delij[n]; - arg3j3 = arg3j3 - d_arho3b(j,n) * delij[n]; + arg1i1 = arg1i1 + d_arho1(i, n) * delij[n]; + arg1j1 = arg1j1 - d_arho1(j, n) * delij[n]; + arg3i3 = arg3i3 + d_arho3b(i, n) * delij[n]; + arg3j3 = arg3j3 - d_arho3b(j, n) * delij[n]; } // rho0 terms @@ -262,21 +282,23 @@ MEAMKokkos::operator()(TagMEAMForce, const int &ii, EV_FL drho1dr2 = a1 * (drhoa1i - rhoa1i / rij) * arg1j1; a1 = 2.0 * sij / rij; for (m = 0; m < 3; m++) { - drho1drm1[m] = a1 * rhoa1j * d_arho1(i,m); - drho1drm2[m] = -a1 * rhoa1i * d_arho1(j,m); + drho1drm1[m] = a1 * rhoa1j * d_arho1(i, m); + drho1drm2[m] = -a1 * rhoa1i * d_arho1(j, m); } // rho2 terms a2 = 2 * sij / rij2; - drho2dr1 = a2 * (drhoa2j - 2 * rhoa2j / rij) * arg1i2 - 2.0 / 3.0 * d_arho2b[i] * drhoa2j * sij; - drho2dr2 = a2 * (drhoa2i - 2 * rhoa2i / rij) * arg1j2 - 2.0 / 3.0 * d_arho2b[j] * drhoa2i * sij; + drho2dr1 = + a2 * (drhoa2j - 2 * rhoa2j / rij) * arg1i2 - 2.0 / 3.0 * d_arho2b[i] * drhoa2j * sij; + drho2dr2 = + a2 * (drhoa2i - 2 * rhoa2i / rij) * arg1j2 - 2.0 / 3.0 * d_arho2b[j] * drhoa2i * sij; a2 = 4 * sij / rij2; for (m = 0; m < 3; m++) { drho2drm1[m] = 0.0; drho2drm2[m] = 0.0; for (n = 0; n < 3; n++) { - drho2drm1[m] = drho2drm1[m] + d_arho2(i,vind2D[m][n]) * delij[n]; - drho2drm2[m] = drho2drm2[m] - d_arho2(j,vind2D[m][n]) * delij[n]; + drho2drm1[m] = drho2drm1[m] + d_arho2(i, vind2D[m][n]) * delij[n]; + drho2drm2[m] = drho2drm2[m] - d_arho2(j, vind2D[m][n]) * delij[n]; } drho2drm1[m] = a2 * rhoa2j * drho2drm1[m]; drho2drm2[m] = -a2 * rhoa2i * drho2drm2[m]; @@ -286,8 +308,10 @@ MEAMKokkos::operator()(TagMEAMForce, const int &ii, EV_FL rij3 = rij * rij2; a3 = 2 * sij / rij3; a3a = 6.0 / 5.0 * sij / rij; - drho3dr1 = a3 * (drhoa3j - 3 * rhoa3j / rij) * arg1i3 - a3a * (drhoa3j - rhoa3j / rij) * arg3i3; - drho3dr2 = a3 * (drhoa3i - 3 * rhoa3i / rij) * arg1j3 - a3a * (drhoa3i - rhoa3i / rij) * arg3j3; + drho3dr1 = + a3 * (drhoa3j - 3 * rhoa3j / rij) * arg1i3 - a3a * (drhoa3j - rhoa3j / rij) * arg3i3; + drho3dr2 = + a3 * (drhoa3i - 3 * rhoa3i / rij) * arg1j3 - a3a * (drhoa3i - rhoa3i / rij) * arg3j3; a3 = 6 * sij / rij3; a3a = 6 * sij / (5 * rij); for (m = 0; m < 3; m++) { @@ -297,31 +321,31 @@ MEAMKokkos::operator()(TagMEAMForce, const int &ii, EV_FL for (n = 0; n < 3; n++) { for (p = n; p < 3; p++) { arg = delij[n] * delij[p] * v2D[nv2]; - drho3drm1[m] = drho3drm1[m] + d_arho3(i,vind3D[m][n][p]) * arg; - drho3drm2[m] = drho3drm2[m] + d_arho3(j,vind3D[m][n][p]) * arg; + drho3drm1[m] = drho3drm1[m] + d_arho3(i, vind3D[m][n][p]) * arg; + drho3drm2[m] = drho3drm2[m] + d_arho3(j, vind3D[m][n][p]) * arg; nv2 = nv2 + 1; } } - drho3drm1[m] = (a3 * drho3drm1[m] - a3a * d_arho3b(i,m)) * rhoa3j; - drho3drm2[m] = (-a3 * drho3drm2[m] + a3a * d_arho3b(j,m)) * rhoa3i; + drho3drm1[m] = (a3 * drho3drm1[m] - a3a * d_arho3b(i, m)) * rhoa3j; + drho3drm2[m] = (-a3 * drho3drm2[m] + a3a * d_arho3b(j, m)) * rhoa3i; } // Compute derivatives of weighting functions t wrt rij - t1i = d_t_ave(i,0); - t2i = d_t_ave(i,1); - t3i = d_t_ave(i,2); - t1j = d_t_ave(j,0); - t2j = d_t_ave(j,1); - t3j = d_t_ave(j,2); + t1i = d_t_ave(i, 0); + t2i = d_t_ave(i, 1); + t3i = d_t_ave(i, 2); + t1j = d_t_ave(j, 0); + t2j = d_t_ave(j, 1); + t3j = d_t_ave(j, 2); if (ialloy == 1) { - a1i = fdiv_zero_kk(drhoa0j * sij, d_tsq_ave(i,0)); - a1j = fdiv_zero_kk(drhoa0i * sij, d_tsq_ave(j,0)); - a2i = fdiv_zero_kk(drhoa0j * sij, d_tsq_ave(i,1)); - a2j = fdiv_zero_kk(drhoa0i * sij, d_tsq_ave(j,1)); - a3i = fdiv_zero_kk(drhoa0j * sij, d_tsq_ave(i,2)); - a3j = fdiv_zero_kk(drhoa0i * sij, d_tsq_ave(j,2)); + a1i = fdiv_zero_kk(drhoa0j * sij, d_tsq_ave(i, 0)); + a1j = fdiv_zero_kk(drhoa0i * sij, d_tsq_ave(j, 0)); + a2i = fdiv_zero_kk(drhoa0j * sij, d_tsq_ave(i, 1)); + a2j = fdiv_zero_kk(drhoa0i * sij, d_tsq_ave(j, 1)); + a3i = fdiv_zero_kk(drhoa0j * sij, d_tsq_ave(i, 2)); + a3j = fdiv_zero_kk(drhoa0i * sij, d_tsq_ave(j, 2)); dt1dr1 = a1i * (t1mj - t1i * MathSpecialKokkos::square(t1mj)); dt1dr2 = a1j * (t1mi - t1j * MathSpecialKokkos::square(t1mi)); @@ -342,11 +366,9 @@ MEAMKokkos::operator()(TagMEAMForce, const int &ii, EV_FL } else { ai = 0.0; - if (!iszero_kk(d_rho0[i])) - ai = drhoa0j * sij / d_rho0[i]; + if (!iszero_kk(d_rho0[i])) ai = drhoa0j * sij / d_rho0[i]; aj = 0.0; - if (!iszero_kk(d_rho0[j])) - aj = drhoa0i * sij / d_rho0[j]; + if (!iszero_kk(d_rho0[j])) aj = drhoa0i * sij / d_rho0[j]; dt1dr1 = ai * (t1mj - t1i); dt1dr2 = aj * (t1mi - t1j); @@ -361,19 +383,22 @@ MEAMKokkos::operator()(TagMEAMForce, const int &ii, EV_FL get_shpfcn(lattce_meam[eltj][eltj], stheta_meam[elti][elti], ctheta_meam[elti][elti], shpj); drhodr1 = d_dgamma1[i] * drho0dr1 + - d_dgamma2[i] * (dt1dr1 * d_rho1[i] + t1i * drho1dr1 + dt2dr1 * d_rho2[i] + t2i * drho2dr1 + - dt3dr1 * d_rho3[i] + t3i * drho3dr1) - - d_dgamma3[i] * (shpi[0] * dt1dr1 + shpi[1] * dt2dr1 + shpi[2] * dt3dr1); + d_dgamma2[i] * + (dt1dr1 * d_rho1[i] + t1i * drho1dr1 + dt2dr1 * d_rho2[i] + t2i * drho2dr1 + + dt3dr1 * d_rho3[i] + t3i * drho3dr1) - + d_dgamma3[i] * (shpi[0] * dt1dr1 + shpi[1] * dt2dr1 + shpi[2] * dt3dr1); drhodr2 = d_dgamma1[j] * drho0dr2 + - d_dgamma2[j] * (dt1dr2 * d_rho1[j] + t1j * drho1dr2 + dt2dr2 * d_rho2[j] + t2j * drho2dr2 + - dt3dr2 * d_rho3[j] + t3j * drho3dr2) - - d_dgamma3[j] * (shpj[0] * dt1dr2 + shpj[1] * dt2dr2 + shpj[2] * dt3dr2); + d_dgamma2[j] * + (dt1dr2 * d_rho1[j] + t1j * drho1dr2 + dt2dr2 * d_rho2[j] + t2j * drho2dr2 + + dt3dr2 * d_rho3[j] + t3j * drho3dr2) - + d_dgamma3[j] * (shpj[0] * dt1dr2 + shpj[1] * dt2dr2 + shpj[2] * dt3dr2); for (m = 0; m < 3; m++) { drhodrm1[m] = 0.0; drhodrm2[m] = 0.0; - drhodrm1[m] = d_dgamma2[i] * (t1i * drho1drm1[m] + t2i * drho2drm1[m] + t3i * drho3drm1[m]); - drhodrm2[m] = d_dgamma2[j] * (t1j * drho1drm2[m] + t2j * drho2drm2[m] + t3j * drho3drm2[m]); - + drhodrm1[m] = + d_dgamma2[i] * (t1i * drho1drm1[m] + t2i * drho2drm1[m] + t3i * drho3drm1[m]); + drhodrm2[m] = + d_dgamma2[j] * (t1j * drho1drm2[m] + t2j * drho2drm2[m] + t3j * drho3drm2[m]); } // Compute derivatives wrt sij, but only if necessary @@ -392,12 +417,12 @@ MEAMKokkos::operator()(TagMEAMForce, const int &ii, EV_FL drho3ds2 = a3 * rhoa3i * arg1j3 - a3a * rhoa3i * arg3j3; if (ialloy == 1) { - a1i = fdiv_zero_kk(rhoa0j, d_tsq_ave(i,0)); - a1j = fdiv_zero_kk(rhoa0i, d_tsq_ave(j,0)); - a2i = fdiv_zero_kk(rhoa0j, d_tsq_ave(i,1)); - a2j = fdiv_zero_kk(rhoa0i, d_tsq_ave(j,1)); - a3i = fdiv_zero_kk(rhoa0j, d_tsq_ave(i,2)); - a3j = fdiv_zero_kk(rhoa0i, d_tsq_ave(j,2)); + a1i = fdiv_zero_kk(rhoa0j, d_tsq_ave(i, 0)); + a1j = fdiv_zero_kk(rhoa0i, d_tsq_ave(j, 0)); + a2i = fdiv_zero_kk(rhoa0j, d_tsq_ave(i, 1)); + a2j = fdiv_zero_kk(rhoa0i, d_tsq_ave(j, 1)); + a3i = fdiv_zero_kk(rhoa0j, d_tsq_ave(i, 2)); + a3j = fdiv_zero_kk(rhoa0i, d_tsq_ave(j, 2)); dt1ds1 = a1i * (t1mj - t1i * MathSpecialKokkos::square(t1mj)); dt1ds2 = a1j * (t1mi - t1j * MathSpecialKokkos::square(t1mi)); @@ -418,11 +443,9 @@ MEAMKokkos::operator()(TagMEAMForce, const int &ii, EV_FL } else { ai = 0.0; - if (!iszero_kk(d_rho0[i])) - ai = rhoa0j / d_rho0[i]; + if (!iszero_kk(d_rho0[i])) ai = rhoa0j / d_rho0[i]; aj = 0.0; - if (!iszero_kk(d_rho0[j])) - aj = rhoa0i / d_rho0[j]; + if (!iszero_kk(d_rho0[j])) aj = rhoa0i / d_rho0[j]; dt1ds1 = ai * (t1mj - t1i); dt1ds2 = aj * (t1mi - t1j); @@ -433,13 +456,15 @@ MEAMKokkos::operator()(TagMEAMForce, const int &ii, EV_FL } drhods1 = d_dgamma1[i] * drho0ds1 + - d_dgamma2[i] * (dt1ds1 * d_rho1[i] + t1i * drho1ds1 + dt2ds1 * d_rho2[i] + t2i * drho2ds1 + - dt3ds1 * d_rho3[i] + t3i * drho3ds1) - - d_dgamma3[i] * (shpi[0] * dt1ds1 + shpi[1] * dt2ds1 + shpi[2] * dt3ds1); + d_dgamma2[i] * + (dt1ds1 * d_rho1[i] + t1i * drho1ds1 + dt2ds1 * d_rho2[i] + t2i * drho2ds1 + + dt3ds1 * d_rho3[i] + t3i * drho3ds1) - + d_dgamma3[i] * (shpi[0] * dt1ds1 + shpi[1] * dt2ds1 + shpi[2] * dt3ds1); drhods2 = d_dgamma1[j] * drho0ds2 + - d_dgamma2[j] * (dt1ds2 * d_rho1[j] + t1j * drho1ds2 + dt2ds2 * d_rho2[j] + t2j * drho2ds2 + - dt3ds2 * d_rho3[j] + t3j * drho3ds2) - - d_dgamma3[j] * (shpj[0] * dt1ds2 + shpj[1] * dt2ds2 + shpj[2] * dt3ds2); + d_dgamma2[j] * + (dt1ds2 * d_rho1[j] + t1j * drho1ds2 + dt2ds2 * d_rho2[j] + t2j * drho2ds2 + + dt3ds2 * d_rho3[j] + t3j * drho3ds2) - + d_dgamma3[j] * (shpj[0] * dt1ds2 + shpj[1] * dt2ds2 + shpj[2] * dt3ds2); } // Compute derivatives of energy wrt rij, sij and rij[3] @@ -456,8 +481,8 @@ MEAMKokkos::operator()(TagMEAMForce, const int &ii, EV_FL force = dUdrij * recip + dUdsij * d_dscrfcn[fnoffset + jn]; for (m = 0; m < 3; m++) { forcem = delij[m] * force + dUdrijm[m]; - a_f(i,m) += forcem; - a_f(j,m) -= forcem; + a_f(i, m) += forcem; + a_f(j, m) -= forcem; } // Tabulate per-atom virial as symmetrized stress tensor @@ -474,33 +499,32 @@ MEAMKokkos::operator()(TagMEAMForce, const int &ii, EV_FL v[5] = -0.25 * (delij[1] * fi[2] + delij[2] * fi[1]); if (vflag_global) - for (m = 0; m < 6; m++) - ev.v[m] += 2.0*v[m]; + for (m = 0; m < 6; m++) ev.v[m] += 2.0 * v[m]; if (vflag_atom) { for (m = 0; m < 6; m++) { - a_vatom(i,m) += v[m]; - a_vatom(j,m) += v[m]; + a_vatom(i, m) += v[m]; + a_vatom(j, m) += v[m]; } } } // Now compute forces on other atoms k due to change in sij - if (iszero_kk(sij) || isone_kk(sij)) continue; //: cont jn loop + if (iszero_kk(sij) || isone_kk(sij)) continue; //: cont jn loop double dxik(0), dyik(0), dzik(0); double dxjk(0), dyjk(0), dzjk(0); for (kn = 0; kn < d_numneigh_full[i]; kn++) { - k = d_neighbors_full(i,kn); + k = d_neighbors_full(i, kn); eltk = d_map[type[k]]; if (k != j && eltk >= 0) { double xik, xjk, cikj, sikj, dfc, a; double dCikj1, dCikj2; double delc, rik2, rjk2; - sij = d_scrfcn[jn+fnoffset] * d_fcpair[jn+fnoffset]; + sij = d_scrfcn[jn + fnoffset] * d_fcpair[jn + fnoffset]; const double Cmax = Cmax_meam[elti][eltj][eltk]; const double Cmin = Cmin_meam[elti][eltj][eltk]; @@ -509,14 +533,14 @@ MEAMKokkos::operator()(TagMEAMForce, const int &ii, EV_FL if (!iszero_kk(sij) && !isone_kk(sij)) { const double rbound = rij2 * ebound_meam[elti][eltj]; delc = Cmax - Cmin; - dxjk = x(k,0) - x(j,0); - dyjk = x(k,1) - x(j,1); - dzjk = x(k,2) - x(j,2); + dxjk = x(k, 0) - x(j, 0); + dyjk = x(k, 1) - x(j, 1); + dzjk = x(k, 2) - x(j, 2); rjk2 = dxjk * dxjk + dyjk * dyjk + dzjk * dzjk; if (rjk2 <= rbound) { - dxik = x(k,0) - x(i,0); - dyik = x(k,1) - x(i,1); - dzik = x(k,2) - x(i,2); + dxik = x(k, 0) - x(i, 0); + dyik = x(k, 1) - x(i, 1); + dzik = x(k, 2) - x(i, 2); rik2 = dxik * dxik + dyik * dyik + dzik * dzik; if (rik2 <= rbound) { xik = rik2 / rij2; @@ -541,15 +565,15 @@ MEAMKokkos::operator()(TagMEAMForce, const int &ii, EV_FL force1 = dUdsij * dsij1; force2 = dUdsij * dsij2; - a_f(i,0) += force1 * dxik; - a_f(i,1) += force1 * dyik; - a_f(i,2) += force1 * dzik; - a_f(j,0) += force2 * dxjk; - a_f(j,1) += force2 * dyjk; - a_f(j,2) += force2 * dzjk; - a_f(k,0) -= force1 * dxik + force2 * dxjk; - a_f(k,1) -= force1 * dyik + force2 * dyjk; - a_f(k,2) -= force1 * dzik + force2 * dzjk; + a_f(i, 0) += force1 * dxik; + a_f(i, 1) += force1 * dyik; + a_f(i, 2) += force1 * dzik; + a_f(j, 0) += force2 * dxjk; + a_f(j, 1) += force2 * dyjk; + a_f(j, 2) += force2 * dzjk; + a_f(k, 0) -= force1 * dxik + force2 * dxjk; + a_f(k, 1) -= force1 * dyik + force2 * dyjk; + a_f(k, 2) -= force1 * dzik + force2 * dzjk; // Tabulate per-atom virial as symmetrized stress tensor @@ -568,14 +592,13 @@ MEAMKokkos::operator()(TagMEAMForce, const int &ii, EV_FL v[5] = -sixth * (dyik * fi[2] + dyjk * fj[2] + dzik * fi[1] + dzjk * fj[1]); if (vflag_global) - for (m = 0; m < 6; m++) - ev.v[m] += 3.0*v[m]; + for (m = 0; m < 6; m++) ev.v[m] += 3.0 * v[m]; if (vflag_atom) { for (m = 0; m < 6; m++) { - a_vatom(i,m) += v[m]; - a_vatom(j,m) += v[m]; - a_vatom(k,m) += v[m]; + a_vatom(i, m) += v[m]; + a_vatom(j, m) += v[m]; + a_vatom(k, m) += v[m]; } } } diff --git a/src/KOKKOS/meam_kokkos.h b/src/KOKKOS/meam_kokkos.h index 74f815e912..1f289d6a4f 100644 --- a/src/KOKKOS/meam_kokkos.h +++ b/src/KOKKOS/meam_kokkos.h @@ -14,47 +14,43 @@ #ifndef LMP_MEAMKOKKOS_H #define LMP_MEAMKOKKOS_H +#include "kokkos.h" #include "meam.h" #include "memory_kokkos.h" #include "neigh_request.h" #include "neighbor_kokkos.h" -#include "kokkos.h" #include #include namespace LAMMPS_NS { -struct TagMEAMDensFinal{}; -template -struct TagMEAMDensInit{}; -struct TagMEAMZero{}; -template -struct TagMEAMForce{}; +struct TagMEAMDensFinal {}; +template struct TagMEAMDensInit { +}; +struct TagMEAMZero {}; +template struct TagMEAMForce { +}; -template -class MEAMKokkos : public MEAM -{ +template class MEAMKokkos : public MEAM { public: typedef ArrayTypes AT; typedef EV_FLOAT value_type; - MEAMKokkos(Memory* mem); + MEAMKokkos(Memory *mem); ~MEAMKokkos() override; KOKKOS_INLINE_FUNCTION - void operator()(TagMEAMDensFinal, const int&, EV_FLOAT&) const; + void operator()(TagMEAMDensFinal, const int &, EV_FLOAT &) const; - template - KOKKOS_INLINE_FUNCTION - void operator()(TagMEAMDensInit, const int&) const; + template + KOKKOS_INLINE_FUNCTION void operator()(TagMEAMDensInit, const int &) const; KOKKOS_INLINE_FUNCTION - void operator()(TagMEAMZero, const int&) const; + void operator()(TagMEAMZero, const int &) const; + + template + KOKKOS_INLINE_FUNCTION void operator()(TagMEAMForce, const int &, EV_FLOAT &) const; - template - KOKKOS_INLINE_FUNCTION - void operator()(TagMEAMForce, const int&, EV_FLOAT&) const; private: - // parameters to meam_dens_init int ntype, nlocal; @@ -79,48 +75,51 @@ class MEAMKokkos : public MEAM public: void meam_dens_setup(int, int, int) override; - void meam_setup_done(double*) override; - void meam_dens_init(int, int, typename AT::t_int_1d, typename AT::t_int_1d, typename AT::t_x_array, - typename AT::t_int_1d, typename AT::t_int_1d, typename AT::t_int_1d, - typename AT::t_neighbors_2d, typename AT::t_neighbors_2d, typename AT::t_int_1d, - int, int); - void meam_dens_final(int, int, int, int, typename ArrayTypes::t_efloat_1d, - int, typename AT::t_int_1d, typename AT::t_int_1d, typename AT::t_int_2d, int&, EV_FLOAT&); - void meam_force(int, int, int, int, int, typename ArrayTypes::t_efloat_1d, - int, typename AT::t_int_1d, typename AT::t_int_1d, typename AT::t_x_array, typename AT::t_int_1d, - typename AT::t_int_1d, typename AT::t_f_array, typename ArrayTypes::t_virial_array, - typename AT::t_int_1d, typename AT::t_int_1d, typename AT::t_neighbors_2d, typename AT::t_neighbors_2d, - int, int, EV_FLOAT&); - template - KOKKOS_INLINE_FUNCTION - void getscreen(int, int, typename AT::t_x_array, typename AT::t_int_1d, - typename AT::t_int_1d, int, typename AT::t_int_1d, typename AT::t_int_1d) const; - template - KOKKOS_INLINE_FUNCTION - void calc_rho1(int, int, typename AT::t_int_1d, typename AT::t_int_1d, typename AT::t_x_array, typename AT::t_int_1d, int) const; + void meam_setup_done(double *) override; + void meam_dens_init(int, int, typename AT::t_int_1d, typename AT::t_int_1d, + typename AT::t_x_array, typename AT::t_int_1d, typename AT::t_int_1d, + typename AT::t_int_1d, typename AT::t_neighbors_2d, + typename AT::t_neighbors_2d, typename AT::t_int_1d, int, int); + void meam_dens_final(int, int, int, int, typename ArrayTypes::t_efloat_1d, int, + typename AT::t_int_1d, typename AT::t_int_1d, typename AT::t_int_2d, int &, + EV_FLOAT &); + void meam_force(int, int, int, int, int, typename ArrayTypes::t_efloat_1d, int, + typename AT::t_int_1d, typename AT::t_int_1d, typename AT::t_x_array, + typename AT::t_int_1d, typename AT::t_int_1d, typename AT::t_f_array, + typename ArrayTypes::t_virial_array, typename AT::t_int_1d, + typename AT::t_int_1d, typename AT::t_neighbors_2d, typename AT::t_neighbors_2d, + int, int, EV_FLOAT &); + template + KOKKOS_INLINE_FUNCTION void getscreen(int, int, typename AT::t_x_array, typename AT::t_int_1d, + typename AT::t_int_1d, int, typename AT::t_int_1d, + typename AT::t_int_1d) const; + template + KOKKOS_INLINE_FUNCTION void calc_rho1(int, int, typename AT::t_int_1d, typename AT::t_int_1d, + typename AT::t_x_array, typename AT::t_int_1d, int) const; KOKKOS_INLINE_FUNCTION double fcut(const double xi) const; KOKKOS_INLINE_FUNCTION - double dfcut(const double xi, double& dfc) const; + double dfcut(const double xi, double &dfc) const; KOKKOS_INLINE_FUNCTION double dCfunc(const double, const double, const double) const; KOKKOS_INLINE_FUNCTION - void dCfunc2(const double, const double, const double, double&, double&) const; + void dCfunc2(const double, const double, const double, double &, double &) const; KOKKOS_INLINE_FUNCTION - double G_gam(const double, const int, int&) const; + double G_gam(const double, const int, int &) const; KOKKOS_INLINE_FUNCTION - double dG_gam(const double, const int, double&) const; + double dG_gam(const double, const int, double &) const; KOKKOS_INLINE_FUNCTION double zbl(const double, const int, const int) const; KOKKOS_INLINE_FUNCTION - double embedding(const double, const double, const double, double&) const; + double embedding(const double, const double, const double, double &) const; KOKKOS_INLINE_FUNCTION - double erose(const double, const double, const double, const double, const double, const double, const int) const; + double erose(const double, const double, const double, const double, const double, const double, + const int) const; KOKKOS_INLINE_FUNCTION - void get_shpfcn(const lattice_t latt, const double sthe, const double cthe, - double (&s)[3]) const; + void get_shpfcn(const lattice_t latt, const double sthe, const double cthe, double (&s)[3]) const; KOKKOS_INLINE_FUNCTION int get_Zij(const lattice_t) const; + public: DAT::tdual_ffloat_1d k_rho, k_rho0, k_rho1, k_rho2, k_rho3, k_frhop; typename ArrayTypes::t_ffloat_1d d_rho, d_rho0, d_rho1, d_rho2, d_rho3, d_frhop; @@ -129,9 +128,11 @@ class MEAMKokkos : public MEAM typename ArrayTypes::t_ffloat_1d d_gamma, d_dgamma1, d_dgamma2, d_dgamma3, d_arho2b; HAT::t_ffloat_1d h_gamma, h_dgamma1, h_dgamma2, h_dgamma3, h_arho2b; DAT::tdual_ffloat_2d k_arho1, k_arho2, k_arho3, k_arho3b, k_t_ave, k_tsq_ave; - typename ArrayTypes::t_ffloat_2d d_arho1, d_arho2, d_arho3, d_arho3b, d_t_ave, d_tsq_ave; + typename ArrayTypes::t_ffloat_2d d_arho1, d_arho2, d_arho3, d_arho3b, d_t_ave, + d_tsq_ave; HAT::t_ffloat_2d h_arho1, h_arho2, h_arho3, h_arho3b, h_t_ave, h_tsq_ave; - typename ArrayTypes::t_ffloat_2d d_phir, d_phirar, d_phirar1, d_phirar2, d_phirar3, d_phirar4, d_phirar5, d_phirar6; + typename ArrayTypes::t_ffloat_2d d_phir, d_phirar, d_phirar1, d_phirar2, d_phirar3, + d_phirar4, d_phirar5, d_phirar6; DAT::tdual_ffloat_1d k_scrfcn, k_dscrfcn, k_fcpair; typename ArrayTypes::t_ffloat_1d d_scrfcn, d_dscrfcn, d_fcpair; HAT::t_ffloat_1d h_scrfcn, h_dscrfcn, h_fcpair; @@ -140,56 +141,84 @@ class MEAMKokkos : public MEAM int need_dup; using KKDeviceType = typename KKDevice::value; - template - using DupScatterView = KKScatterView; + template + using DupScatterView = + KKScatterView; - template - using NonDupScatterView = KKScatterView; + template + using NonDupScatterView = + KKScatterView; - DupScatterView dup_rho0; - NonDupScatterView ndup_rho0; - DupScatterView dup_arho2b; - NonDupScatterView ndup_arho2b; - DupScatterView dup_arho1; - NonDupScatterView ndup_arho1; - DupScatterView dup_arho2; - NonDupScatterView ndup_arho2; - DupScatterView dup_arho3; - NonDupScatterView ndup_arho3; - DupScatterView dup_arho3b; - NonDupScatterView ndup_arho3b; - DupScatterView dup_t_ave; - NonDupScatterView ndup_t_ave; - DupScatterView dup_tsq_ave; - NonDupScatterView ndup_tsq_ave; + DupScatterView + dup_rho0; + NonDupScatterView + ndup_rho0; + DupScatterView + dup_arho2b; + NonDupScatterView + ndup_arho2b; + DupScatterView + dup_arho1; + NonDupScatterView + ndup_arho1; + DupScatterView + dup_arho2; + NonDupScatterView + ndup_arho2; + DupScatterView + dup_arho3; + NonDupScatterView + ndup_arho3; + DupScatterView + dup_arho3b; + NonDupScatterView + ndup_arho3b; + DupScatterView + dup_t_ave; + NonDupScatterView + ndup_t_ave; + DupScatterView + dup_tsq_ave; + NonDupScatterView + ndup_tsq_ave; DupScatterView dup_f; NonDupScatterView ndup_f; - DupScatterView dup_eatom; - NonDupScatterView ndup_eatom; - DupScatterView dup_vatom; - NonDupScatterView ndup_vatom; + DupScatterView + dup_eatom; + NonDupScatterView + ndup_eatom; + DupScatterView + dup_vatom; + NonDupScatterView + ndup_vatom; }; KOKKOS_INLINE_FUNCTION -static bool iszero_kk(const double f) { +static bool iszero_kk(const double f) +{ return fabs(f) < 1e-20; } KOKKOS_INLINE_FUNCTION -static bool isone_kk(const double f) { - return fabs(f-1.0) < 1e-20; +static bool isone_kk(const double f) +{ + return fabs(f - 1.0) < 1e-20; } KOKKOS_INLINE_FUNCTION -static double fdiv_zero_kk(const double n, const double d) { - if (iszero_kk(d)) - return 0.0; +static double fdiv_zero_kk(const double n, const double d) +{ + if (iszero_kk(d)) return 0.0; return n / d; } // Functions we need for compat -} +} // namespace LAMMPS_NS #include "meam_impl_kokkos.h" #endif From ae26b489dd63a71f0d0eca276f6ccf3bf5fe1aaf Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 1 Jul 2022 21:25:57 -0400 Subject: [PATCH 508/585] fix typo --- src/KOKKOS/meam_dens_final_kokkos.h | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/KOKKOS/meam_dens_final_kokkos.h b/src/KOKKOS/meam_dens_final_kokkos.h index 5d1c9926b7..a3b95e837d 100644 --- a/src/KOKKOS/meam_dens_final_kokkos.h +++ b/src/KOKKOS/meam_dens_final_kokkos.h @@ -40,7 +40,7 @@ MEAMKokkos::meam_dens_final(int nlocal, int eflag_either, int eflag_ copymode = 1; Kokkos::parallel_reduce(Kokkos::RangePolicy(0,nlocal),*this,ev); - ev_all.evdwl =+ ev.evdwl; + ev_all.evdwl += ev.evdwl; copymode = 0; auto h_errorflag = Kokkos::create_mirror_view_and_copy(LMPHostType(),d_errorflag); From b81df6a72005f948bcf7af165344e17bb8067943 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 1 Jul 2022 21:26:06 -0400 Subject: [PATCH 509/585] silence compiler warnings --- src/KOKKOS/pair_meam_kokkos.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/KOKKOS/pair_meam_kokkos.cpp b/src/KOKKOS/pair_meam_kokkos.cpp index 47e5ab8f96..c0f18a2969 100644 --- a/src/KOKKOS/pair_meam_kokkos.cpp +++ b/src/KOKKOS/pair_meam_kokkos.cpp @@ -308,7 +308,7 @@ void PairMEAMKokkos::init_style() template int PairMEAMKokkos::pack_forward_comm_kokkos(int n, DAT::tdual_int_2d k_sendlist, int iswap_in, DAT::tdual_xfloat_1d &buf, - int pbc_flag, int *pbc) + int /*pbc_flag*/, int * /*pbc*/) { d_sendlist = k_sendlist.view(); iswap = iswap_in; From e98af882422074770d696c0fa14e389da3ce6fa4 Mon Sep 17 00:00:00 2001 From: rohskopf Date: Fri, 1 Jul 2022 20:56:11 -0600 Subject: [PATCH 510/585] Clean up unnecessary code. --- examples/snap/compute_snap_dgrad.py | 2 +- src/ML-SNAP/compute_snap.cpp | 447 ++++++---------------------- src/ML-SNAP/compute_snap.h | 9 +- 3 files changed, 95 insertions(+), 363 deletions(-) diff --git a/examples/snap/compute_snap_dgrad.py b/examples/snap/compute_snap_dgrad.py index 95f2e1fa55..0919af8598 100644 --- a/examples/snap/compute_snap_dgrad.py +++ b/examples/snap/compute_snap_dgrad.py @@ -6,7 +6,7 @@ Purpose: Demonstrate extraction of descriptor gradient (dB/dR) array from comput Serial syntax: python compute_snap_dgrad.py Parallel syntax: - mpirun -np 2 python compute_snap_dgrad.py + mpirun -np 4 python compute_snap_dgrad.py """ from __future__ import print_function diff --git a/src/ML-SNAP/compute_snap.cpp b/src/ML-SNAP/compute_snap.cpp index 52c1b32fbc..25c5c488fa 100644 --- a/src/ML-SNAP/compute_snap.cpp +++ b/src/ML-SNAP/compute_snap.cpp @@ -208,7 +208,11 @@ ComputeSnap::ComputeSnap(LAMMPS *lmp, int narg, char **arg) : if (bikflag) bik_rows = natoms; dgrad_rows = ndims_force*natoms; size_array_rows = bik_rows+dgrad_rows + ndims_virial; - if (dgradflag) size_array_cols = nperdim + 3; + if (dgradflag){ + size_array_rows = bik_rows + 3*natoms*natoms + 1; + size_array_cols = nperdim + 3; + error->warning(FLERR,"dgradflag=1 creates a N^2 array, beware of large systems."); + } else size_array_cols = nperdim*atom->ntypes + 1; lastcol = size_array_cols-1; @@ -236,13 +240,7 @@ ComputeSnap::~ComputeSnap() memory->destroy(sinnerelem); memory->destroy(dinnerelem); } - if (dgradflag){ - memory->destroy(dgrad); - memory->destroy(nneighs); - memory->destroy(neighsum); - memory->destroy(icounter); - memory->destroy(dbiri); - } + } /* ---------------------------------------------------------------------- */ @@ -306,9 +304,6 @@ void ComputeSnap::init_list(int /*id*/, NeighList *ptr) void ComputeSnap::compute_array() { - if (dgradflag) get_dgrad_length(); - // if (dgradflag) get_dgrad_length2(); - int ntotal = atom->nlocal + atom->nghost; invoked_array = update->ntimestep; @@ -448,195 +443,130 @@ void ComputeSnap::compute_array() for (int jj = 0; jj < ninside; jj++) { const int j = snaptr->inside[jj]; - if (dgradflag){ - dgrad_row_indx = 3*neighsum[atom->tag[j]-1] + 3*icounter[atom->tag[j]-1] ; - icounter[atom->tag[j]-1] += 1; - } - snaptr->compute_duidrj(jj); snaptr->compute_dbidrj(); // accumulate dBi/dRi, -dBi/dRj - if (!dgradflag) { + if (!dgradflag) { - double *snadi = snap_peratom[i]+typeoffset_local; - double *snadj = snap_peratom[j]+typeoffset_local; + double *snadi = snap_peratom[i]+typeoffset_local; + double *snadj = snap_peratom[j]+typeoffset_local; - for (int icoeff = 0; icoeff < ncoeff; icoeff++) { + for (int icoeff = 0; icoeff < ncoeff; icoeff++) { - snadi[icoeff] += snaptr->dblist[icoeff][0]; - snadi[icoeff+yoffset] += snaptr->dblist[icoeff][1]; - snadi[icoeff+zoffset] += snaptr->dblist[icoeff][2]; + snadi[icoeff] += snaptr->dblist[icoeff][0]; + snadi[icoeff+yoffset] += snaptr->dblist[icoeff][1]; + snadi[icoeff+zoffset] += snaptr->dblist[icoeff][2]; - snadj[icoeff] -= snaptr->dblist[icoeff][0]; - snadj[icoeff+yoffset] -= snaptr->dblist[icoeff][1]; - snadj[icoeff+zoffset] -= snaptr->dblist[icoeff][2]; - } + snadj[icoeff] -= snaptr->dblist[icoeff][0]; + snadj[icoeff+yoffset] -= snaptr->dblist[icoeff][1]; + snadj[icoeff+zoffset] -= snaptr->dblist[icoeff][2]; + } - if (quadraticflag) { - const int quadraticoffset = ncoeff; - snadi += quadraticoffset; - snadj += quadraticoffset; - int ncount = 0; - for (int icoeff = 0; icoeff < ncoeff; icoeff++) { - double bi = snaptr->blist[icoeff]; - double bix = snaptr->dblist[icoeff][0]; - double biy = snaptr->dblist[icoeff][1]; - double biz = snaptr->dblist[icoeff][2]; + if (quadraticflag) { + const int quadraticoffset = ncoeff; + snadi += quadraticoffset; + snadj += quadraticoffset; + int ncount = 0; + for (int icoeff = 0; icoeff < ncoeff; icoeff++) { + double bi = snaptr->blist[icoeff]; + double bix = snaptr->dblist[icoeff][0]; + double biy = snaptr->dblist[icoeff][1]; + double biz = snaptr->dblist[icoeff][2]; - // diagonal elements of quadratic matrix + // diagonal elements of quadratic matrix - double dbxtmp = bi*bix; - double dbytmp = bi*biy; - double dbztmp = bi*biz; + double dbxtmp = bi*bix; + double dbytmp = bi*biy; + double dbztmp = bi*biz; - snadi[ncount] += dbxtmp; - snadi[ncount+yoffset] += dbytmp; - snadi[ncount+zoffset] += dbztmp; - snadj[ncount] -= dbxtmp; - snadj[ncount+yoffset] -= dbytmp; - snadj[ncount+zoffset] -= dbztmp; + snadi[ncount] += dbxtmp; + snadi[ncount+yoffset] += dbytmp; + snadi[ncount+zoffset] += dbztmp; + snadj[ncount] -= dbxtmp; + snadj[ncount+yoffset] -= dbytmp; + snadj[ncount+zoffset] -= dbztmp; - ncount++; + ncount++; - // upper-triangular elements of quadratic matrix + // upper-triangular elements of quadratic matrix - for (int jcoeff = icoeff+1; jcoeff < ncoeff; jcoeff++) { - double dbxtmp = bi*snaptr->dblist[jcoeff][0] - + bix*snaptr->blist[jcoeff]; - double dbytmp = bi*snaptr->dblist[jcoeff][1] - + biy*snaptr->blist[jcoeff]; - double dbztmp = bi*snaptr->dblist[jcoeff][2] - + biz*snaptr->blist[jcoeff]; + for (int jcoeff = icoeff+1; jcoeff < ncoeff; jcoeff++) { + double dbxtmp = bi*snaptr->dblist[jcoeff][0] + + bix*snaptr->blist[jcoeff]; + double dbytmp = bi*snaptr->dblist[jcoeff][1] + + biy*snaptr->blist[jcoeff]; + double dbztmp = bi*snaptr->dblist[jcoeff][2] + + biz*snaptr->blist[jcoeff]; - snadi[ncount] += dbxtmp; - snadi[ncount+yoffset] += dbytmp; - snadi[ncount+zoffset] += dbztmp; - snadj[ncount] -= dbxtmp; - snadj[ncount+yoffset] -= dbytmp; - snadj[ncount+zoffset] -= dbztmp; + snadi[ncount] += dbxtmp; + snadi[ncount+yoffset] += dbytmp; + snadi[ncount+zoffset] += dbztmp; + snadj[ncount] -= dbxtmp; + snadj[ncount+yoffset] -= dbytmp; + snadj[ncount+zoffset] -= dbztmp; - ncount++; - } + ncount++; + } + } + } + } else { - } + for (int icoeff = 0; icoeff < ncoeff; icoeff++) { - } + // add to snap array for this proc - } else { + // dBi/dRj - for (int icoeff = 0; icoeff < ncoeff; icoeff++) { + snap[bik_rows + ((atom->tag[j]-1)*3*natoms) + 3*(atom->tag[i]-1) + 0][icoeff+3] -= snaptr->dblist[icoeff][0]; + snap[bik_rows + ((atom->tag[j]-1)*3*natoms) + 3*(atom->tag[i]-1) + 1][icoeff+3] -= snaptr->dblist[icoeff][1]; + snap[bik_rows + ((atom->tag[j]-1)*3*natoms) + 3*(atom->tag[i]-1) + 2][icoeff+3] -= snaptr->dblist[icoeff][2]; - // sign convention same as compute snad - /* - dgrad[dgrad_row_indx+0][icoeff] = -snaptr->dblist[icoeff][0]; - dgrad[dgrad_row_indx+1][icoeff] = -snaptr->dblist[icoeff][1]; - dgrad[dgrad_row_indx+2][icoeff] = -snaptr->dblist[icoeff][2]; + // dBi/dRi - // accumulate dBi/dRi = sum (-dBi/dRj) for neighbors j of if i + snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 0][icoeff+3] += snaptr->dblist[icoeff][0]; + snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 1][icoeff+3] += snaptr->dblist[icoeff][1]; + snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 2][icoeff+3] += snaptr->dblist[icoeff][2]; + } - dbiri[3*(atom->tag[i]-1)+0][icoeff] += snaptr->dblist[icoeff][0]; - dbiri[3*(atom->tag[i]-1)+1][icoeff] += snaptr->dblist[icoeff][1]; - dbiri[3*(atom->tag[i]-1)+2][icoeff] += snaptr->dblist[icoeff][2]; - */ + } - // add to snap array for this proc - // dBi/dRj - snap[bik_rows + ((atom->tag[j]-1)*3*natoms) + 3*(atom->tag[i]-1) + 0][icoeff+3] -= snaptr->dblist[icoeff][0]; - snap[bik_rows + ((atom->tag[j]-1)*3*natoms) + 3*(atom->tag[i]-1) + 1][icoeff+3] -= snaptr->dblist[icoeff][1]; - snap[bik_rows + ((atom->tag[j]-1)*3*natoms) + 3*(atom->tag[i]-1) + 2][icoeff+3] -= snaptr->dblist[icoeff][2]; - // dBi/dRi - snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 0][icoeff+3] += snaptr->dblist[icoeff][0]; - snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 1][icoeff+3] += snaptr->dblist[icoeff][1]; - snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 2][icoeff+3] += snaptr->dblist[icoeff][2]; - } - - /* - dgrad[dgrad_row_indx+0][ncoeff] = atom->tag[i]-1; - dgrad[dgrad_row_indx+0][ncoeff+1] = atom->tag[j]-1; - dgrad[dgrad_row_indx+0][ncoeff+2] = 0; - dgrad[dgrad_row_indx+1][ncoeff] = atom->tag[i]-1; - dgrad[dgrad_row_indx+1][ncoeff+1] = atom->tag[j]-1; - dgrad[dgrad_row_indx+1][ncoeff+2] = 1; - dgrad[dgrad_row_indx+2][ncoeff] = atom->tag[i]-1; - dgrad[dgrad_row_indx+2][ncoeff+1] = atom->tag[j]-1; - dgrad[dgrad_row_indx+2][ncoeff+2] = 2; - - dbiri[3*(atom->tag[i]-1)+0][ncoeff] = atom->tag[i]-1; - dbiri[3*(atom->tag[i]-1)+0][ncoeff+1] = atom->tag[i]-1; - dbiri[3*(atom->tag[i]-1)+0][ncoeff+2] = 0; - - dbiri[3*(atom->tag[i]-1)+1][ncoeff] = atom->tag[i]-1; - dbiri[3*(atom->tag[i]-1)+1][ncoeff+1] = atom->tag[i]-1; - dbiri[3*(atom->tag[i]-1)+1][ncoeff+2] = 1; - - dbiri[3*(atom->tag[i]-1)+2][ncoeff] = atom->tag[i]-1; - dbiri[3*(atom->tag[i]-1)+2][ncoeff+1] = atom->tag[i]-1; - dbiri[3*(atom->tag[i]-1)+2][ncoeff+2] = 2; - */ - - // add to snap array for this proc - // dBi/dRj tags - /* - snap[bik_rows + ((atom->tag[j]-1)*3*natoms) + 3*(atom->tag[i]-1) + 0][0] = atom->tag[i]-1; - snap[bik_rows + ((atom->tag[j]-1)*3*natoms) + 3*(atom->tag[i]-1) + 0][1] = atom->tag[j]-1; - snap[bik_rows + ((atom->tag[j]-1)*3*natoms) + 3*(atom->tag[i]-1) + 0][2] = 0; - snap[bik_rows + ((atom->tag[j]-1)*3*natoms) + 3*(atom->tag[i]-1) + 1][0] = atom->tag[i]-1; - snap[bik_rows + ((atom->tag[j]-1)*3*natoms) + 3*(atom->tag[i]-1) + 1][1] = atom->tag[j]-1; - snap[bik_rows + ((atom->tag[j]-1)*3*natoms) + 3*(atom->tag[i]-1) + 1][2] = 1; - snap[bik_rows + ((atom->tag[j]-1)*3*natoms) + 3*(atom->tag[i]-1) + 2][0] = atom->tag[i]-1; - snap[bik_rows + ((atom->tag[j]-1)*3*natoms) + 3*(atom->tag[i]-1) + 2][1] = atom->tag[j]-1; - snap[bik_rows + ((atom->tag[j]-1)*3*natoms) + 3*(atom->tag[i]-1) + 2][2] = 2; - */ - - // dBi/dRi tags - /* - snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 0][0] = atom->tag[i]-1; - snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 0][1] = atom->tag[i]-1; - snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 0][2] = 0; - snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 1][0] = atom->tag[i]-1; - snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 1][1] = atom->tag[i]-1; - snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 1][2] = 1; - snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 2][0] = atom->tag[i]-1; - snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 2][1] = atom->tag[i]-1; - snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 2][2] = 2; - */ - - } -} // loop over jj inside + } // loop over jj inside // accumulate Bi if (!dgradflag) { - // linear contributions + // linear contributions int k = typeoffset_global; for (int icoeff = 0; icoeff < ncoeff; icoeff++) snap[irow][k++] += snaptr->blist[icoeff]; - // quadratic contributions + // quadratic contributions - if (quadraticflag) { - for (int icoeff = 0; icoeff < ncoeff; icoeff++) { - double bveci = snaptr->blist[icoeff]; - snap[irow][k++] += 0.5*bveci*bveci; - for (int jcoeff = icoeff+1; jcoeff < ncoeff; jcoeff++) { - double bvecj = snaptr->blist[jcoeff]; - snap[irow][k++] += bveci*bvecj; - } - } - } + if (quadraticflag) { + for (int icoeff = 0; icoeff < ncoeff; icoeff++) { + double bveci = snaptr->blist[icoeff]; + snap[irow][k++] += 0.5*bveci*bveci; + for (int jcoeff = icoeff+1; jcoeff < ncoeff; jcoeff++) { + double bvecj = snaptr->blist[jcoeff]; + snap[irow][k++] += bveci*bvecj; + } + } + } } else { - int k = 3; - for (int icoeff = 0; icoeff < ncoeff; icoeff++) - snap[irow][k++] += snaptr->blist[icoeff]; - numneigh_sum += ninside; - } - } - } + int k = 3; + for (int icoeff = 0; icoeff < ncoeff; icoeff++) + snap[irow][k++] += snaptr->blist[icoeff]; + numneigh_sum += ninside; + } + + } // if (mask[i] & groupbit) + + } // for (int ii = 0; ii < inum; ii++) { // accumulate bispectrum force contributions to global array @@ -657,8 +587,6 @@ void ComputeSnap::compute_array() } } - } else { - } // accumulate forces to global array @@ -702,9 +630,8 @@ void ComputeSnap::compute_array() } else { - // Assign reference energy right after the dgrad rows, first column. - // Add 3N for the dBi/dRi rows. - //int irow = bik_rows + dgrad_rows + 3*natoms; + // assign reference energy right after the dgrad rows, first column + int irow = bik_rows + 3*natoms*natoms; double reference_energy = c_pe->compute_scalar(); snapall[irow][0] = reference_energy; @@ -766,194 +693,6 @@ void ComputeSnap::dbdotr_compute() } } -/* ---------------------------------------------------------------------- - compute dgrad length -------------------------------------------------------------------------- */ - -void ComputeSnap::get_dgrad_length() -{ - - rank = universe->me; // for MPI debugging - - memory->destroy(snap); - memory->destroy(snapall); - - // invoke full neighbor list - - neighbor->build_one(list); - dgrad_rows = 0; - const int inum = list->inum; - const int* const ilist = list->ilist; - const int* const numneigh = list->numneigh; - int** const firstneigh = list->firstneigh; - int * const type = atom->type; - const int* const mask = atom->mask; - double** const x = atom->x; - - memory->create(neighsum, natoms, "snap:neighsum"); - memory->create(nneighs, natoms, "snap:nneighs"); - memory->create(icounter, natoms, "snap:icounter"); - memory->create(dbiri, 3*natoms,ncoeff+3, "snap:dbiri"); - //if (atom->nlocal != natoms) - // error->all(FLERR,"Compute snap dgradflag=1 does not support parallelism yet."); - - for (int ii = 0; ii < 3 * natoms; ii++) - for (int icoeff = 0; icoeff < ncoeff; icoeff++) - dbiri[ii][icoeff] = 0.0; - - for (int ii = 0; ii < inum; ii++) { - const int i = ilist[ii]; - if (mask[i] & groupbit) { - icounter[i] = 0; - nneighs[i] = 0; - const double xtmp = x[i][0]; - const double ytmp = x[i][1]; - const double ztmp = x[i][2]; - const int itype = type[i]; - const int* const jlist = firstneigh[i]; - const int jnum = numneigh[i]; - for (int jj = 0; jj < jnum; jj++) { - int j = jlist[jj]; - j &= NEIGHMASK; - - const double delx = x[j][0] - xtmp; - const double dely = x[j][1] - ytmp; - const double delz = x[j][2] - ztmp; - const double rsq = delx * delx + dely * dely + delz * delz; - int jtype = type[j]; - - if (rsq < cutsq[itype][jtype] && rsq>1e-20) { - dgrad_rows++; - nneighs[i]++; - } - } - } - } - - dgrad_rows *= ndims_force; - - neighsum[0] = 0; - for (int ii = 1; ii < inum; ii++) { - const int i = ilist[ii]; - if (mask[i] & groupbit) - neighsum[i] = neighsum[i-1] + nneighs[i-1]; - } - - memory->create(dgrad, dgrad_rows, ncoeff+3, "snap:dgrad"); - for (int i = 0; i < dgrad_rows; i++) - for (int j = 0; j < ncoeff+3; j++) - dgrad[i][j] = 0.0; - - // set size array rows which now depends on dgrad_rows. - - //size_array_rows = bik_rows + dgrad_rows + 3*atom->nlocal + 1; // Add 3*N for dBi/dRi. and add 1 for reference energy - size_array_rows = bik_rows + 3*natoms*natoms + 1; - //printf("----- dgrad_rows, 3*natoms*natoms: %d %d\n", dgrad_rows, 3*natoms*natoms); - - memory->create(snap,size_array_rows,size_array_cols, "snap:snap"); - memory->create(snapall,size_array_rows,size_array_cols, "snap:snapall"); - array = snapall; - -} - -/* ---------------------------------------------------------------------- - compute dgrad length -------------------------------------------------------------------------- */ - -void ComputeSnap::get_dgrad_length2() -{ - memory->destroy(snap); - memory->destroy(snapall); - - // invoke full neighbor list - - neighbor->build_one(list); - dgrad_rows = 0; - const int inum = list->inum; - const int* const ilist = list->ilist; - const int* const numneigh = list->numneigh; - int** const firstneigh = list->firstneigh; - int * const type = atom->type; - const int* const mask = atom->mask; - double** const x = atom->x; - - memory->create(neighsum, natoms, "snap:neighsum"); - memory->create(nneighs, natoms, "snap:nneighs"); - memory->create(icounter, natoms, "snap:icounter"); - memory->create(dbiri, 3*natoms,ncoeff+3, "snap:dbiri"); - if (atom->nlocal != natoms) - error->all(FLERR,"Compute snap dgradflag=1 does not support parallelism yet."); - - for (int ii = 0; ii < 3 * natoms; ii++) - for (int icoeff = 0; icoeff < ncoeff; icoeff++) - dbiri[ii][icoeff] = 0.0; - - for (int ii = 0; ii < inum; ii++) { - const int i = ilist[ii]; - if (mask[i] & groupbit) { - icounter[i] = 0; - nneighs[i] = 0; - const double xtmp = x[i][0]; - const double ytmp = x[i][1]; - const double ztmp = x[i][2]; - const int itype = type[i]; - const int* const jlist = firstneigh[i]; - const int jnum = numneigh[i]; - for (int jj = 0; jj < jnum; jj++) { - int j = jlist[jj]; - j &= NEIGHMASK; - - const double delx = x[j][0] - xtmp; - const double dely = x[j][1] - ytmp; - const double delz = x[j][2] - ztmp; - const double rsq = delx * delx + dely * dely + delz * delz; - int jtype = type[j]; - - if (rsq < cutsq[itype][jtype] && rsq>1e-20) { - dgrad_rows++; - nneighs[i]++; - } - } - } - } - - dgrad_rows *= ndims_force; - - // loop over all atoms again to calculate neighsum - - // for (int ii = 0; ii < inum; ii++) { - // const int i = ilist[ii]; - // if (mask[i] & groupbit) { - // for (int jj = 0; jj < ii; jj++) { - // const int j = ilist[jj]; - // if (mask[j] & groupbit) - // neighsum[i] += nneighs[j]; - // } - // } - // } - - neighsum[0] = 0; - for (int ii = 1; ii < inum; ii++) { - const int i = ilist[ii]; - if (mask[i] & groupbit) - neighsum[i] = neighsum[i-1] + nneighs[i-1]; - } - - memory->create(dgrad, dgrad_rows, ncoeff+3, "snap:dgrad"); - for (int i = 0; i < dgrad_rows; i++) - for (int j = 0; j < ncoeff+3; j++) - dgrad[i][j] = 0.0; - - // set size array rows which now depends on dgrad_rows. - - size_array_rows = bik_rows + dgrad_rows + 3*atom->nlocal + 1; // Add 3*N for dBi/dRi. and add 1 for reference energy - - memory->create(snap,size_array_rows,size_array_cols, "snap:snap"); - memory->create(snapall,size_array_rows,size_array_cols, "snap:snapall"); - array = snapall; - -} - /* ---------------------------------------------------------------------- memory usage ------------------------------------------------------------------------- */ diff --git a/src/ML-SNAP/compute_snap.h b/src/ML-SNAP/compute_snap.h index e1fb7cee49..a89a870fe8 100644 --- a/src/ML-SNAP/compute_snap.h +++ b/src/ML-SNAP/compute_snap.h @@ -53,20 +53,13 @@ class ComputeSnap : public Compute { double cutmax; int quadraticflag; int bikflag, bik_rows, dgradflag, dgrad_rows; - double **dgrad; // First ncoeff columns are descriptor derivatives. - // Last 3 columns are indices i,j,a - double **dbiri; // dBi/dRi = sum(-dBi/dRj) over neighbors j - int *nneighs; // number of neighs inside the snap cutoff. - int *neighsum; - int *icounter; // counting atoms i for each j. int rank; Compute *c_pe; Compute *c_virial; void dbdotr_compute(); - void get_dgrad_length(); - void get_dgrad_length2(); + }; } // namespace LAMMPS_NS From 581503888f776895356dd08026ab6f0eb1550aa7 Mon Sep 17 00:00:00 2001 From: rohskopf Date: Fri, 1 Jul 2022 21:07:19 -0600 Subject: [PATCH 511/585] Updated docs. --- doc/src/compute_sna_atom.rst | 16 +++++----------- 1 file changed, 5 insertions(+), 11 deletions(-) diff --git a/doc/src/compute_sna_atom.rst b/doc/src/compute_sna_atom.rst index e2655585f3..37705ff005 100644 --- a/doc/src/compute_sna_atom.rst +++ b/doc/src/compute_sna_atom.rst @@ -464,15 +464,8 @@ gradient components where :math:`a` is the Cartesian direction for the gradient. The rows are organized in chunks, where each chunk corresponds to an atom :math:`j` in the system of :math:`N` atoms. The rows in an atom :math:`j` chunk correspond to -atoms :math:`i` that have :math:`j` as a neighbor. The number of rows in the -atom :math:`j` chunk is therefore equal to the number of neighbors -:math:`N_{neighs}[j]` within the SNAP potential cutoff radius of atom :math:`j` -, times 3 for each Cartesian direction. The total number of rows for these -descriptor gradients is therefore - -.. math:: - - 3 \sum_j^{N} N_{neighs}[j]. +atoms :math:`i` in the system of :math:`N` atoms. The total number of rows for +these descriptor gradients is therefore :math:`3N^2`. For *dgradflag=1*, the number of columns is equal to the number of bispectrum components, plus 3 additional columns representing the indices :math:`i`, :math:`j`, and :math:`a` which @@ -483,8 +476,9 @@ For the descriptor gradient rows, the first 3 columns contain the indices of different descriptors indexed by :math:`k`. The first 3 columns of the first :math:`N` rows belong to the reference potential force components. The first column of the last row, after the first -:math:`N + 3 \sum_j^{N} N_{neighs}[j]` rows, contains the reference potential -energy. The virial components are not used with this option. +:math:`N + 3N^2` rows, contains the reference potential +energy. The virial components are not used with this option. The total number of +rows is therefore :math:`N + 3N^2 + 1` and the number of columns is :math:`K + 3`. These values can be accessed by any command that uses per-atom values from a compute as input. See the :doc:`Howto output ` doc From 39b01a901f24e289ad08ab9dfe3867048ace3518 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sat, 2 Jul 2022 11:23:59 -0400 Subject: [PATCH 512/585] print warning when using I/O redirection with parallel runs --- src/lammps.cpp | 12 ++++++++---- 1 file changed, 8 insertions(+), 4 deletions(-) diff --git a/src/lammps.cpp b/src/lammps.cpp index c74983be43..4ddbe42db3 100644 --- a/src/lammps.cpp +++ b/src/lammps.cpp @@ -446,8 +446,7 @@ LAMMPS::LAMMPS(int narg, char **arg, MPI_Comm communicator) : // sum of procs in all worlds must equal total # of procs if (!universe->consistent()) - error->universe_all(FLERR,"Processor partitions do not match " - "number of allocated processors"); + error->universe_all(FLERR,"Processor partitions do not match number of allocated processors"); // universe cannot use stdin for input file @@ -516,10 +515,15 @@ LAMMPS::LAMMPS(int narg, char **arg, MPI_Comm communicator) : else infile = fopen(arg[inflag],"r"); if (infile == nullptr) error->one(FLERR,"Cannot open input script {}: {}", arg[inflag], utils::getsyserror()); + if (!helpflag) + utils::logmesg(this,fmt::format("LAMMPS ({}{})\n",version,UPDATE_STRING)); + // warn against using I/O redirection in parallel runs + if ((inflag == 0) && (universe->nprocs > 1)) + error->warning(FLERR, "Using I/O redirection is unreliable with parallel runs. " + "Better use -in switch to read input file."); + utils::flush_buffers(this); } - if ((universe->me == 0) && !helpflag) - utils::logmesg(this,fmt::format("LAMMPS ({}{})\n",version,UPDATE_STRING)); // universe is one or more worlds, as setup by partition switch // split universe communicator into separate world communicators From f38a417a32d658c228ef50d23db68307c6e4d80e Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sat, 2 Jul 2022 17:08:22 -0400 Subject: [PATCH 513/585] restore user facing keyword back to "threebody" defaulting to "on" also some minor updates: - streamline description in the documentation, add links/references - print message when disabling threebody terms - improve error messages, simplify argument processing --- doc/src/pair_sw.rst | 91 ++++++++++++++++------------ doc/src/pair_sw_angle_table.rst | 3 +- src/MANYBODY/pair_sw.cpp | 29 ++++----- src/MANYBODY/pair_sw_angle_table.cpp | 4 +- src/MANYBODY/pair_sw_mod.cpp | 11 ++-- 5 files changed, 75 insertions(+), 63 deletions(-) diff --git a/doc/src/pair_sw.rst b/doc/src/pair_sw.rst index a83f446a07..b2305dab5e 100644 --- a/doc/src/pair_sw.rst +++ b/doc/src/pair_sw.rst @@ -24,17 +24,16 @@ Syntax pair_style style keyword values * style = *sw* or *sw/mod* -* keyword = *maxdelcs* or *skip_threebody* +* keyword = *maxdelcs* or *threebody* .. parsed-literal:: - *maxdelcs* value = delta1 delta2 (optional) + *maxdelcs* value = delta1 delta2 (optional, sw/mod only) delta1 = The minimum thershold for the variation of cosine of three-body angle delta2 = The maximum threshold for the variation of cosine of three-body angle - *skip_threebody* value = *on* or *off* (optional) - off (default) = Compute both the three-body and two-body terms of the potential - on = Compute only the two-body term of the potential - + *threebody* value = *on* or *off* (optional, sw only) + on (default) = Compute both the three-body and two-body terms of the potential + off = Compute only the two-body term of the potential Examples """""""" @@ -48,7 +47,7 @@ Examples pair_style sw/mod maxdelcs 0.25 0.35 pair_coeff * * tmd.sw.mod Mo S S - pair_style hybrid sw sw skip_threebody on + pair_style hybrid sw threebody on sw threebody off pair_coeff * * sw 1 mW_xL.sw mW NULL pair_coeff 1 2 sw 2 mW_xL.sw mW xL pair_coeff 2 2 sw 2 mW_xL.sw mW xL @@ -77,22 +76,25 @@ three-body term. The summations in the formula are over all neighbors J and K of atom I within a cutoff distance :math:`a `\sigma`. The *sw/mod* style is designed for simulations of materials when -distinguishing three-body angles are necessary, such as borophene -and transition metal dichalcogenides, which cannot be described -by the original code for the Stillinger-Weber potential. -For instance, there are several types of angles around each Mo atom in `MoS_2`, -and some unnecessary angle types should be excluded in the three-body interaction. -Such exclusion may be realized by selecting proper angle types directly. -The exclusion of unnecessary angles is achieved here by the cut-off function (`f_C(\delta)`), -which induces only minimum modifications for LAMMPS. +distinguishing three-body angles are necessary, such as borophene and +transition metal dichalcogenides, which cannot be described by the +original code for the Stillinger-Weber potential. For instance, there +are several types of angles around each Mo atom in `MoS_2`, and some +unnecessary angle types should be excluded in the three-body +interaction. Such exclusion may be realized by selecting proper angle +types directly. The exclusion of unnecessary angles is achieved here by +the cut-off function (`f_C(\delta)`), which induces only minimum +modifications for LAMMPS. Validation, benchmark tests, and applications of the *sw/mod* style can be found in :ref:`(Jiang2) ` and :ref:`(Jiang3) `. -The *sw/mod* style computes the energy E of a system of atoms, whose potential -function is mostly the same as the Stillinger-Weber potential. The only modification -is in the three-body term, where the value of :math:`\delta = \cos \theta_{ijk} - \cos \theta_{0ijk}` -used in the original energy and force expression is scaled by a switching factor :math:`f_C(\delta)`: +The *sw/mod* style computes the energy E of a system of atoms, whose +potential function is mostly the same as the Stillinger-Weber +potential. The only modification is in the three-body term, where the +value of :math:`\delta = \cos \theta_{ijk} - \cos \theta_{0ijk}` used in +the original energy and force expression is scaled by a switching factor +:math:`f_C(\delta)`: .. math:: @@ -103,28 +105,38 @@ used in the original energy and force expression is scaled by a switching factor 0 & \left| \delta \right| > \delta_2 \end{array} \right. \\ -This cut-off function decreases smoothly from 1 to 0 over the range :math:`[\delta_1, \delta_2]`. -This smoothly turns off the energy and force contributions for :math:`\left| \delta \right| > \delta_2`. -It is suggested that :math:`\delta 1` and :math:`\delta_2` to be the value around -:math:`0.5 \left| \cos \theta_1 - \cos \theta_2 \right|`, with -:math:`\theta_1` and :math:`\theta_2` as the different types of angles around an atom. -For borophene and transition metal dichalcogenides, :math:`\delta_1 = 0.25` and :math:`\delta_2 = 0.35`. -This value enables the cut-off function to exclude unnecessary angles in the three-body SW terms. +This cut-off function decreases smoothly from 1 to 0 over the range +:math:`[\delta_1, \delta_2]`. This smoothly turns off the energy and +force contributions for :math:`\left| \delta \right| > \delta_2`. It is +suggested that :math:`\delta 1` and :math:`\delta_2` to be the value +around :math:`0.5 \left| \cos \theta_1 - \cos \theta_2 \right|`, with +:math:`\theta_1` and :math:`\theta_2` as the different types of angles +around an atom. For borophene and transition metal dichalcogenides, +:math:`\delta_1 = 0.25` and :math:`\delta_2 = 0.35`. This value enables +the cut-off function to exclude unnecessary angles in the three-body SW +terms. .. note:: - The cut-off function is just to be used as a technique to exclude some unnecessary angles, - and it has no physical meaning. It should be noted that the force and potential are inconsistent - with each other in the decaying range of the cut-off function, as the angle dependence for the - cut-off function is not implemented in the force (first derivation of potential). - However, the angle variation is much smaller than the given threshold value for actual simulations, - so the inconsistency between potential and force can be neglected in actual simulations. + The cut-off function is just to be used as a technique to exclude + some unnecessary angles, and it has no physical meaning. It should be + noted that the force and potential are inconsistent with each other + in the decaying range of the cut-off function, as the angle + dependence for the cut-off function is not implemented in the force + (first derivation of potential). However, the angle variation is + much smaller than the given threshold value for actual simulations, + so the inconsistency between potential and force can be neglected in + actual simulations. -The *skip_threebody* keyword determines whether or not the three-body term of the potential is calculated. -Skipping this significantly increases the speed of the calculation, with the tradeoff that :math:\lambda_{ijk} -is forcibly set to 0. If the keyword is used with the pair styles, sw/gpu, sw/intel, or sw/kokkos, -:math:\lambda_{ijk} will still be forcibly set to 0, but no additional benefits will be gained. This keyword -cannot be used for variants of the sw/mod or sw/angle/table pair styles. +The *threebody* keyword is optional and determines whether or not the +three-body term of the potential is calculated. The default value is +"on" and it is only available for the plain *sw* pair style variants, +but not available for the *sw/mod* and :doc:`sw/angle/table +` pair style variants. To turn off the threebody +contributions all :math:`\lambda_{ijk}` parameters from the potential +file are forcibly set to 0. In addition the pair style implementations +may employ code optimizations for the *threebody off* setting that can +result in significant speedups versus the default. Only a single pair_coeff command is used with the *sw* and *sw/mod* styles which specifies a Stillinger-Weber potential file with parameters for all @@ -297,8 +309,9 @@ Related commands Default """"""" -The default values for the *maxdelcs* setting of the *sw/mod* pair -style are *delta1* = 0.25 and *delta2* = 0.35`. +The default value for the *threebody* setting of the "sw" pair style is +"on", the default values for the "*maxdelcs* setting of the *sw/mod* +pair style are *delta1* = 0.25 and *delta2* = 0.35`. ---------- diff --git a/doc/src/pair_sw_angle_table.rst b/doc/src/pair_sw_angle_table.rst index ff88711d7a..65e73d4445 100644 --- a/doc/src/pair_sw_angle_table.rst +++ b/doc/src/pair_sw_angle_table.rst @@ -296,7 +296,8 @@ for pair interactions. Related commands """""""""""""""" -:doc:`pair_coeff `, :doc:`pair_style sw `, :doc:`pair_style threebody/table ` +:doc:`pair_coeff `, :doc:`pair_style sw `, +:doc:`pair_style threebody/table ` ---------- diff --git a/src/MANYBODY/pair_sw.cpp b/src/MANYBODY/pair_sw.cpp index 3cc402cb5f..b615480754 100644 --- a/src/MANYBODY/pair_sw.cpp +++ b/src/MANYBODY/pair_sw.cpp @@ -44,6 +44,7 @@ PairSW::PairSW(LAMMPS *lmp) : Pair(lmp) manybody_flag = 1; centroidstressflag = CENTROID_NOTAVAIL; unit_convert_flag = utils::get_supported_conversions(utils::ENERGY); + skip_threebody_flag = false; params = nullptr; @@ -172,24 +173,24 @@ void PairSW::compute(int eflag, int vflag) delr1[1] = x[j][1] - ytmp; delr1[2] = x[j][2] - ztmp; rsq1 = delr1[0]*delr1[0] + delr1[1]*delr1[1] + delr1[2]*delr1[2]; - + double fjxtmp,fjytmp,fjztmp; fjxtmp = fjytmp = fjztmp = 0.0; - + for (kk = jj+1; kk < numshort; kk++) { k = neighshort[kk]; ktype = map[type[k]]; ikparam = elem3param[itype][ktype][ktype]; ijkparam = elem3param[itype][jtype][ktype]; - + delr2[0] = x[k][0] - xtmp; delr2[1] = x[k][1] - ytmp; delr2[2] = x[k][2] - ztmp; rsq2 = delr2[0]*delr2[0] + delr2[1]*delr2[1] + delr2[2]*delr2[2]; - + threebody(¶ms[ijparam],¶ms[ikparam],¶ms[ijkparam], rsq1,rsq2,delr1,delr2,fj,fk,eflag,evdwl); - + fxtmp -= fj[0] + fk[0]; fytmp -= fj[1] + fk[1]; fztmp -= fj[2] + fk[2]; @@ -199,7 +200,7 @@ void PairSW::compute(int eflag, int vflag) f[k][0] += fk[0]; f[k][1] += fk[1]; f[k][2] += fk[2]; - + if (evflag) ev_tally3(i,j,k,evdwl,0.0,fj,fk,delr1,delr2); } f[j][0] += fjxtmp; @@ -233,18 +234,15 @@ void PairSW::allocate() void PairSW::settings(int narg, char ** arg) { - // Default - skip_threebody_flag = false; - + // process optional keywords int iarg = 0; - while (iarg < narg) { - if (strcmp(arg[iarg],"skip_threebody") == 0) { - if (iarg+2 > narg) error->all(FLERR,"Illegal pair_style command"); - skip_threebody_flag = utils::logical(FLERR,arg[iarg+1],false,lmp); + if (strcmp(arg[iarg],"threebody") == 0) { + if (iarg+2 > narg) utils::missing_cmd_args(FLERR, "pair_style sw", error); + skip_threebody_flag = !utils::logical(FLERR,arg[iarg+1],false,lmp); one_coeff = !skip_threebody_flag; iarg += 2; - } else error->all(FLERR,"Illegal pair_style command"); + } else error->all(FLERR, "Illegal pair_style sw keyword: {}", arg[iarg]); } } @@ -305,6 +303,8 @@ void PairSW::read_file(char *file) PotentialFileReader reader(lmp, file, "sw", unit_convert_flag); char *line; + if (skip_threebody_flag) utils::logmesg(lmp, " disabling sw potential three-body terms\n"); + // transparently convert units for supported conversions int unit_convert = reader.get_unit_convert(); @@ -369,6 +369,7 @@ void PairSW::read_file(char *file) params[nparams].epsilon *= conversion_factor; } + // turn off three-body term if (skip_threebody_flag) params[nparams].lambda = 0; if (params[nparams].epsilon < 0.0 || params[nparams].sigma < 0.0 || diff --git a/src/MANYBODY/pair_sw_angle_table.cpp b/src/MANYBODY/pair_sw_angle_table.cpp index 7667f77491..5b9339780f 100644 --- a/src/MANYBODY/pair_sw_angle_table.cpp +++ b/src/MANYBODY/pair_sw_angle_table.cpp @@ -759,5 +759,5 @@ void PairSWAngleTable::uf_lookup(ParamTable *pm, double x, double &u, double &f) void PairSWAngleTable::settings(int narg, char **/*arg*/) { - if (narg != 0) error->all(FLERR,"Illegal pair_style command"); -} \ No newline at end of file + if (narg != 0) error->all(FLERR,"Illegal pair_style sw/angle/table command"); +} diff --git a/src/MANYBODY/pair_sw_mod.cpp b/src/MANYBODY/pair_sw_mod.cpp index ce24952fc7..e6d17b0733 100644 --- a/src/MANYBODY/pair_sw_mod.cpp +++ b/src/MANYBODY/pair_sw_mod.cpp @@ -41,21 +41,18 @@ PairSWMOD::PairSWMOD(LAMMPS *lmp) : PairSW(lmp) void PairSWMOD::settings(int narg, char **arg) { - // process optional keywords - + // process optional keywords (and not (yet) optional keywords from parent class). int iarg = 0; - while (iarg < narg) { if (strcmp(arg[iarg],"maxdelcs") == 0) { - if (iarg+3 > narg) error->all(FLERR,"Illegal pair_style command"); + if (iarg+3 > narg) utils::missing_cmd_args(FLERR, "pair_style sw/mod", error); delta1 = utils::numeric(FLERR,arg[iarg+1],false,lmp); delta2 = utils::numeric(FLERR,arg[iarg+2],false,lmp); iarg += 3; if ((delta1 < 0.0) || (delta1 > 1.0) || (delta2 < 0.0) || (delta2 > 1.0) || (delta1 > delta2)) - error->all(FLERR,"Illegal values for maxdelcs keyword"); - } else error->all(FLERR,"Illegal pair_style command"); + error->all(FLERR, "Out of range value(s) for pair style sw/mod maxdelcs keyword"); + } else error->all(FLERR, "Illegal pair_style sw/mod keyword: {}", arg[iarg]); } - PairSW::settings(narg-iarg,arg+iarg); } /* ---------------------------------------------------------------------- */ From 2fa5f7c97e66e1a48ffbb0d53a05542f03a56b8b Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sat, 2 Jul 2022 17:39:01 -0400 Subject: [PATCH 514/585] use a half neighbor list for skip_threebody case for further speedup --- src/INTEL/pair_sw_intel.cpp | 4 ++++ src/KOKKOS/pair_sw_kokkos.cpp | 4 ++++ src/MANYBODY/pair_sw.cpp | 28 ++++++++++++++++++---------- src/OPENMP/pair_sw_omp.cpp | 30 ++++++++++++++++-------------- 4 files changed, 42 insertions(+), 24 deletions(-) diff --git a/src/INTEL/pair_sw_intel.cpp b/src/INTEL/pair_sw_intel.cpp index a882f8bfba..37fe19260a 100644 --- a/src/INTEL/pair_sw_intel.cpp +++ b/src/INTEL/pair_sw_intel.cpp @@ -1101,7 +1101,11 @@ void PairSWIntel::allocate() void PairSWIntel::init_style() { + // there is no support for skipping threebody loops (yet) + bool tmp_threebody = skip_threebody_flag; + skip_threebody_flag = false; PairSW::init_style(); + skip_threebody_flag = tmp_threebody; map[0] = map[1]; diff --git a/src/KOKKOS/pair_sw_kokkos.cpp b/src/KOKKOS/pair_sw_kokkos.cpp index cae0aea0e8..a3d8d11380 100644 --- a/src/KOKKOS/pair_sw_kokkos.cpp +++ b/src/KOKKOS/pair_sw_kokkos.cpp @@ -392,7 +392,11 @@ void PairSWKokkos::coeff(int narg, char **arg) template void PairSWKokkos::init_style() { + // there is no support for skipping threebody loops (yet) + bool tmp_threebody = skip_threebody_flag; + skip_threebody_flag = false; PairSW::init_style(); + skip_threebody_flag = tmp_threebody; // adjust neighbor list request for KOKKOS diff --git a/src/MANYBODY/pair_sw.cpp b/src/MANYBODY/pair_sw.cpp index b615480754..034dcfaf10 100644 --- a/src/MANYBODY/pair_sw.cpp +++ b/src/MANYBODY/pair_sw.cpp @@ -14,6 +14,7 @@ /* ---------------------------------------------------------------------- Contributing author: Aidan Thompson (SNL) + Optimizations for two-body only: Jackson Elowitt (Univ. of Utah) ------------------------------------------------------------------------- */ #include "pair_sw.h" @@ -138,14 +139,18 @@ void PairSW::compute(int eflag, int vflag) } jtag = tag[j]; - if (itag > jtag) { - if ((itag+jtag) % 2 == 0) continue; - } else if (itag < jtag) { - if ((itag+jtag) % 2 == 1) continue; - } else { - if (x[j][2] < ztmp) continue; - if (x[j][2] == ztmp && x[j][1] < ytmp) continue; - if (x[j][2] == ztmp && x[j][1] == ytmp && x[j][0] < xtmp) continue; + + // only need to skip if we have a full neighbor list + if (!skip_threebody_flag) { + if (itag > jtag) { + if ((itag+jtag) % 2 == 0) continue; + } else if (itag < jtag) { + if ((itag+jtag) % 2 == 1) continue; + } else { + if (x[j][2] < ztmp) continue; + if (x[j][2] == ztmp && x[j][1] < ytmp) continue; + if (x[j][2] == ztmp && x[j][1] == ytmp && x[j][0] < xtmp) continue; + } } twobody(¶ms[ijparam],rsq,fpair,eflag,evdwl); @@ -273,9 +278,12 @@ void PairSW::init_style() if (force->newton_pair == 0) error->all(FLERR,"Pair style Stillinger-Weber requires newton pair on"); - // need a full neighbor list + // need a full neighbor list for full threebody calculation - neighbor->add_request(this, NeighConst::REQ_FULL); + if (skip_threebody_flag) + neighbor->add_request(this); + else + neighbor->add_request(this, NeighConst::REQ_FULL); } /* ---------------------------------------------------------------------- diff --git a/src/OPENMP/pair_sw_omp.cpp b/src/OPENMP/pair_sw_omp.cpp index a59922b8c4..4f579a9e90 100644 --- a/src/OPENMP/pair_sw_omp.cpp +++ b/src/OPENMP/pair_sw_omp.cpp @@ -134,14 +134,16 @@ void PairSWOMP::eval(int iifrom, int iito, ThrData * const thr) } jtag = tag[j]; - if (itag > jtag) { - if ((itag+jtag) % 2 == 0) continue; - } else if (itag < jtag) { - if ((itag+jtag) % 2 == 1) continue; - } else { - if (x[j].z < ztmp) continue; - if (x[j].z == ztmp && x[j].y < ytmp) continue; - if (x[j].z == ztmp && x[j].y == ytmp && x[j].x < xtmp) continue; + if (!skip_threebody_flag) { + if (itag > jtag) { + if ((itag+jtag) % 2 == 0) continue; + } else if (itag < jtag) { + if ((itag+jtag) % 2 == 1) continue; + } else { + if (x[j].z < ztmp) continue; + if (x[j].z == ztmp && x[j].y < ytmp) continue; + if (x[j].z == ztmp && x[j].y == ytmp && x[j].x < xtmp) continue; + } } twobody(¶ms[ijparam],rsq,fpair,EFLAG,evdwl); @@ -169,24 +171,24 @@ void PairSWOMP::eval(int iifrom, int iito, ThrData * const thr) delr1[1] = x[j].y - ytmp; delr1[2] = x[j].z - ztmp; rsq1 = delr1[0]*delr1[0] + delr1[1]*delr1[1] + delr1[2]*delr1[2]; - + double fjxtmp,fjytmp,fjztmp; fjxtmp = fjytmp = fjztmp = 0.0; - + for (kk = jj+1; kk < numshort; kk++) { k = neighshort_thr[kk]; ktype = map[type[k]]; ikparam = elem3param[itype][ktype][ktype]; ijkparam = elem3param[itype][jtype][ktype]; - + delr2[0] = x[k].x - xtmp; delr2[1] = x[k].y - ytmp; delr2[2] = x[k].z - ztmp; rsq2 = delr2[0]*delr2[0] + delr2[1]*delr2[1] + delr2[2]*delr2[2]; - + threebody(¶ms[ijparam],¶ms[ikparam],¶ms[ijkparam], rsq1,rsq2,delr1,delr2,fj,fk,EFLAG,evdwl); - + fxtmp -= fj[0] + fk[0]; fytmp -= fj[1] + fk[1]; fztmp -= fj[2] + fk[2]; @@ -196,7 +198,7 @@ void PairSWOMP::eval(int iifrom, int iito, ThrData * const thr) f[k].x += fk[0]; f[k].y += fk[1]; f[k].z += fk[2]; - + if (EVFLAG) ev_tally3_thr(this,i,j,k,evdwl,0.0,fj,fk,delr1,delr2,thr); } f[j].x += fjxtmp; From 67a3a7a6c1efd594a4700436bb9b48393f78e8c8 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sat, 2 Jul 2022 18:02:15 -0400 Subject: [PATCH 515/585] add unit test for twobody off and implement and test single() function --- src/MANYBODY/pair_sw.cpp | 18 +- src/MANYBODY/pair_sw.h | 1 + .../tests/manybody-pair-sw_twobody.yaml | 157 ++++++++++++++++++ 3 files changed, 175 insertions(+), 1 deletion(-) create mode 100644 unittest/force-styles/tests/manybody-pair-sw_twobody.yaml diff --git a/src/MANYBODY/pair_sw.cpp b/src/MANYBODY/pair_sw.cpp index 034dcfaf10..de2a7ac8d6 100644 --- a/src/MANYBODY/pair_sw.cpp +++ b/src/MANYBODY/pair_sw.cpp @@ -245,7 +245,10 @@ void PairSW::settings(int narg, char ** arg) if (strcmp(arg[iarg],"threebody") == 0) { if (iarg+2 > narg) utils::missing_cmd_args(FLERR, "pair_style sw", error); skip_threebody_flag = !utils::logical(FLERR,arg[iarg+1],false,lmp); - one_coeff = !skip_threebody_flag; + // without the threebody terms we don't need to enforce + // pair_coeff * * and can enable the single function. + one_coeff = skip_threebody_flag ? 0 : 1; + single_enable = skip_threebody_flag ? 1 : 0; iarg += 2; } else error->all(FLERR, "Illegal pair_style sw keyword: {}", arg[iarg]); } @@ -299,6 +302,19 @@ double PairSW::init_one(int i, int j) /* ---------------------------------------------------------------------- */ +double PairSW::single(int /*i*/, int /*j*/, int itype, int jtype, double rsq, + double /*factor_coul*/, double /*factor_lj*/, double &fforce) +{ + int ijparam = elem3param[map[itype]][map[jtype]][map[jtype]]; + double phisw = 0.0; + fforce = 0.0; + + if (rsq < params[ijparam].cutsq) twobody(¶ms[ijparam],rsq,fforce,1,phisw); + return phisw; +} + +/* ---------------------------------------------------------------------- */ + void PairSW::read_file(char *file) { memory->sfree(params); diff --git a/src/MANYBODY/pair_sw.h b/src/MANYBODY/pair_sw.h index aa0aef228e..bcc7227554 100644 --- a/src/MANYBODY/pair_sw.h +++ b/src/MANYBODY/pair_sw.h @@ -32,6 +32,7 @@ class PairSW : public Pair { void coeff(int, char **) override; double init_one(int, int) override; void init_style() override; + double single(int, int, int, int, double, double, double, double &) override; static constexpr int NPARAMS_PER_LINE = 14; diff --git a/unittest/force-styles/tests/manybody-pair-sw_twobody.yaml b/unittest/force-styles/tests/manybody-pair-sw_twobody.yaml new file mode 100644 index 0000000000..42d3cebf81 --- /dev/null +++ b/unittest/force-styles/tests/manybody-pair-sw_twobody.yaml @@ -0,0 +1,157 @@ +--- +lammps_version: 23 Jun 2022 +tags: generated +date_generated: Sat Jul 2 17:42:21 2022 +epsilon: 1e-10 +skip_tests: +prerequisites: ! | + pair sw +pre_commands: ! | + variable newton_pair delete + if "$(is_active(package,gpu)) > 0.0" then "variable newton_pair index off" else "variable newton_pair index on" +post_commands: ! "" +input_file: in.manybody +pair_style: sw threebody off +pair_coeff: ! | + * * Si.sw Si Si Si Si Si Si Si Si +extract: ! "" +natoms: 64 +init_vdwl: -258.5086400674769 +init_coul: 0 +init_stress: ! |2- + 6.4784557236140188e+00 8.9666141338671075e+00 1.6564010213468620e+01 -4.9679217055624925e+00 3.4388959220521961e+01 7.5389343797929154e-01 +init_forces: ! |2 + 1 -7.5117950925001264e-01 3.0512035938320858e+00 1.7548369060319577e+00 + 2 -2.5839943840157944e+00 -6.2407030855132184e-01 -2.0776063043681416e+00 + 3 6.4874626526429646e-01 -1.9191097130296589e-01 -2.8953907507008203e-01 + 4 -1.8780621641443120e+00 2.9563493639001268e+00 6.0045000947756955e-01 + 5 -1.3527836952861758e+00 -7.5563316408513048e-01 -4.0171785277050770e-01 + 6 3.0261027539317009e-01 3.3010495375946016e+00 1.0578432546004755e+00 + 7 -1.0220792530722718e+00 -8.9704171544868350e-01 2.2679286915120240e+00 + 8 7.3786854090375081e-02 6.8184832716858157e-01 -9.9742395408331985e-01 + 9 1.5404185888118715e-01 -2.4234656391168983e+00 -2.5547421021459220e+00 + 10 2.9152006680754144e-01 -1.3832499077045937e+00 -2.3112314100238849e+00 + 11 3.0397941651131566e+00 -3.2696818086952382e+00 2.0402858500342536e+00 + 12 -5.2427750818963892e+00 -2.9266181850189747e+00 -2.3274218711162238e+00 + 13 -3.4764983756087076e-01 5.1759636691465873e+00 -9.5777981490571462e-01 + 14 -1.3994974411693033e+00 3.6723581318644940e+00 4.9022891744156372e-01 + 15 -3.6451950102391031e+00 4.1804831124641382e+00 -2.3094319497556559e+00 + 16 1.7762576801244847e+00 -1.7769734947711013e-01 5.6118226682874788e+00 + 17 1.1626276987569719e+00 2.5434318242406255e+00 -4.1298909446437833e+00 + 18 2.6370967308167081e-01 4.8174395544262438e-01 3.2879300848711184e+00 + 19 -1.2180668170296169e+00 -2.0218982136836656e+00 -3.8444674827692227e-01 + 20 -6.1734234441618661e+00 -8.7047552939678141e-02 7.4088977580926274e-01 + 21 2.2527604735738231e+00 9.2512650808085084e-01 -2.7596546519202407e+00 + 22 -5.0794028512678571e+00 3.2609137644938517e+00 -3.9745643191135742e+00 + 23 1.8924999787954402e+00 3.3526647080652703e+00 1.2248568956854238e+00 + 24 1.5743771798508372e+00 1.3293691279058384e+00 2.6631027667815861e+00 + 25 8.3110919566309338e-01 -1.1460141214066610e-01 1.4368370341871295e+00 + 26 -4.7991049590854340e-01 -6.7362488036409351e-01 1.2327946774343894e+00 + 27 1.9900573442863836e+00 -5.0620688348406084e-01 1.5762361423313080e+00 + 28 5.7701286079414915e-01 1.3187742370100088e+00 4.1298244042734957e+00 + 29 -3.0416482921788530e+00 9.1958118398971411e-01 -1.1418981151511567e+00 + 30 -1.5986340571260498e+00 1.2172058599377520e+00 -8.9839567436920520e-01 + 31 -1.6221367664137194e+00 1.4053388522714974e+00 -4.1030835758060596e-01 + 32 -3.3999213065003993e+00 5.4646623792746152e-01 -4.9970596852221305e-01 + 33 4.3374523080961502e+00 -2.0526192390847231e+00 2.7863621822774527e+00 + 34 3.6899966300377274e-01 -9.7647298273011718e-02 3.7849094767735275e-01 + 35 1.2474956459695217e+00 -1.6786310914928160e-01 2.5255688468039841e+00 + 36 1.9423002050777016e-02 -2.5811032787101440e+00 -5.3464409483959238e-02 + 37 -1.7991755427583054e+00 1.7326288527074167e+00 -2.3172591544605829e+00 + 38 -2.6635345675769728e-01 -4.5619472453099841e-01 2.9146619578940203e-01 + 39 2.2040425723147274e+00 -1.2990665525340543e+00 -4.1031233229148558e+00 + 40 3.8636879669801210e+00 -1.9428932057790562e+00 -1.2090029697953577e+00 + 41 6.9184862237524347e-02 -5.5563025877752470e-01 -1.0104421056432380e+00 + 42 -4.1077204842477482e+00 -1.9092260092568061e+00 -2.7778884577312546e-01 + 43 6.9234276916198878e-01 -5.1959961009882676e+00 -3.8252772226000875e-01 + 44 3.1974368019332173e+00 -3.7333126721070280e+00 1.1927602690851384e+00 + 45 -1.0979421463666958e+00 1.4281871410588294e+00 -2.7844688870636198e+00 + 46 -2.3123927283410217e-01 -1.6246499267294727e+00 4.6068188624710249e+00 + 47 2.4575638270171467e+00 1.3529111936752543e+00 8.5779610605164602e-01 + 48 1.3053149069961443e+00 5.5515699432490484e-01 -3.4671208564970402e-01 + 49 -1.6274632987918105e+00 -4.7057286351454088e+00 -2.4249279782812732e+00 + 50 5.4224455439310093e-03 2.9897586979430217e+00 -1.3950914387971693e+00 + 51 -1.2459066473548792e+00 2.9456460712366876e+00 3.7288916669729959e+00 + 52 4.2616245425615205e+00 -4.4802874559504291e+00 4.4417404910061506e+00 + 53 2.7936251596841610e+00 2.8362368635929394e+00 1.5493162393308044e+00 + 54 2.4623429186012755e+00 -2.8582750315396499e+00 -1.7184511417663617e+00 + 55 8.8879734150460621e-01 -2.9956850724190431e+00 -3.5690867805221691e+00 + 56 -4.2180992335342177e-01 2.9462851508525678e-01 -2.1026878944189669e+00 + 57 1.9534125277666281e-01 -1.1222033415899244e+00 -3.0127694733977195e-01 + 58 2.7751167493305626e+00 -9.6251009716841951e-01 1.2847140239740573e+00 + 59 2.7332664305562209e+00 1.6874001147167499e+00 -1.8630365579739607e+00 + 60 -1.9920742303178285e+00 -5.1976595137487056e+00 -2.5715712256855774e+00 + 61 -3.9186643718089481e-01 1.8941052818415300e+00 -7.2852310082079819e-01 + 62 -2.6017296078018819e+00 2.4477411514482621e+00 -2.1740532348808825e+00 + 63 1.6751774499211520e+00 -2.9786131173037549e+00 -4.4746311293685642e-02 + 64 2.2350712682686380e+00 2.4856397598318205e+00 6.0442073184431777e+00 +run_vdwl: -258.499584619321 +run_coul: 0 +run_stress: ! |2- + 6.4308150527103614e+00 8.9800084577004764e+00 1.6644352826777482e+01 -5.0072836166618568e+00 3.4219822049720790e+01 1.0492755818511172e+00 +run_forces: ! |2 + 1 -7.5937225945191122e-01 3.0453338820624811e+00 1.7588997466292056e+00 + 2 -2.5842358982706677e+00 -6.4961465564128662e-01 -2.0836136472876197e+00 + 3 6.1692053064565644e-01 -1.7923404289185974e-01 -2.5776384969836241e-01 + 4 -1.8642434201915430e+00 2.9689111966333672e+00 5.7860631771456472e-01 + 5 -1.3707214670175785e+00 -7.6882987771621347e-01 -3.8201327706453814e-01 + 6 3.5155029154762341e-01 3.3059375310476078e+00 1.0816937673465203e+00 + 7 -1.0031791908316097e+00 -8.6956258363515204e-01 2.2425245701191070e+00 + 8 5.9471905500604189e-02 6.7712638453434015e-01 -9.9455163342941122e-01 + 9 1.3241459971784919e-01 -2.4451165559600572e+00 -2.5688790543810329e+00 + 10 2.7987760793693212e-01 -1.3869445644157263e+00 -2.2737317068259308e+00 + 11 3.0093494238363268e+00 -3.2460329093478379e+00 2.0365059309648439e+00 + 12 -5.2407947220384763e+00 -2.9126835314212682e+00 -2.3181888620032565e+00 + 13 -2.9313171694052698e-01 5.1682815539279954e+00 -9.3178794848643598e-01 + 14 -1.4205609885169097e+00 3.6728355747283463e+00 4.7973399101037340e-01 + 15 -3.6438539671591643e+00 4.1738585973197502e+00 -2.2995365264114347e+00 + 16 1.7665430094094714e+00 -1.6683625143013525e-01 5.5980371284228605e+00 + 17 1.1609229005729407e+00 2.5445052813433287e+00 -4.1101936902212186e+00 + 18 2.3250564926704054e-01 5.0119516573696155e-01 3.2999642189792304e+00 + 19 -1.2455755116140121e+00 -2.0483645027853807e+00 -3.9915953456529252e-01 + 20 -6.1533476323819203e+00 -1.0336110065476412e-01 7.2207408198501155e-01 + 21 2.2580812268964414e+00 8.8665782585823316e-01 -2.7867801730661323e+00 + 22 -5.0715437260287493e+00 3.2720805913066657e+00 -3.9870515109961557e+00 + 23 1.9067384153660658e+00 3.3666024181351721e+00 1.2360966484469924e+00 + 24 1.6076366668181861e+00 1.3129049141466476e+00 2.6481286770383776e+00 + 25 8.2849608759830151e-01 -1.0946573631083545e-01 1.4137379099564085e+00 + 26 -4.9245162995242880e-01 -6.5633188499443484e-01 1.2397189435323861e+00 + 27 2.0002068209516661e+00 -5.2635863568453822e-01 1.5812202387080725e+00 + 28 5.6469856769551852e-01 1.3419655823448202e+00 4.1390158656307525e+00 + 29 -3.0414702840012948e+00 9.2717141813720239e-01 -1.1446412926158587e+00 + 30 -1.5780449202280797e+00 1.1972994610432468e+00 -9.0937832538133612e-01 + 31 -1.6135468940121711e+00 1.4097747951848163e+00 -4.1013831792153099e-01 + 32 -3.3839861094060888e+00 5.3294244523688450e-01 -5.1150418397488095e-01 + 33 4.3179202422054406e+00 -2.0530236039826524e+00 2.7909047875298811e+00 + 34 3.6044665483098232e-01 -9.6636898593039144e-02 3.8719889716901629e-01 + 35 1.2574806392912055e+00 -1.5474474915601943e-01 2.5284696614854756e+00 + 36 -9.2507293281644375e-03 -2.5688826605251358e+00 -8.8917022692741904e-02 + 37 -1.7874734690581056e+00 1.7150271178647891e+00 -2.3271057624958509e+00 + 38 -2.4661620498076103e-01 -4.4857619626472056e-01 3.0090275233366270e-01 + 39 2.1876463817083560e+00 -1.2953665685718856e+00 -4.1070251548878520e+00 + 40 3.8954619284502536e+00 -1.9483835119233155e+00 -1.2227531289486768e+00 + 41 9.7565025130135041e-02 -5.2646053136013127e-01 -9.8280124384883183e-01 + 42 -4.1063684952413535e+00 -1.9251952021816745e+00 -2.9901720065849435e-01 + 43 6.7939692714052213e-01 -5.1874569217280806e+00 -3.9562141807204243e-01 + 44 3.2038887558507829e+00 -3.7312345150786044e+00 1.1791192854596575e+00 + 45 -1.1219574440264417e+00 1.4017870123386482e+00 -2.7737869798443779e+00 + 46 -2.3209294883861276e-01 -1.6182897275443398e+00 4.6296975809710883e+00 + 47 2.4602350208971560e+00 1.3452019899041738e+00 8.6358301884597988e-01 + 48 1.3093376440414450e+00 5.7371015819685922e-01 -3.5578408564713881e-01 + 49 -1.6696474765985014e+00 -4.7474039477977401e+00 -2.4607694981777248e+00 + 50 1.2989593641085595e-02 2.9812087098985032e+00 -1.4123464138675532e+00 + 51 -1.2853374902017087e+00 2.9768731587433548e+00 3.7403754374802158e+00 + 52 4.2768627438095859e+00 -4.4665207635055904e+00 4.4526942886426610e+00 + 53 2.8263576162367916e+00 2.8711821643474851e+00 1.6198032393140254e+00 + 54 2.4557393026757914e+00 -2.8576870371250496e+00 -1.7106753514157151e+00 + 55 8.7016650440839127e-01 -2.9993943594233912e+00 -3.5406400607258477e+00 + 56 -4.2720269240408387e-01 2.6284724466018883e-01 -2.0965871396618168e+00 + 57 1.8938909101993642e-01 -1.1500277319075947e+00 -3.0413618657652775e-01 + 58 2.7772395410738167e+00 -9.4351277181421578e-01 1.2588196612829914e+00 + 59 2.7573808165218825e+00 1.7074121472099479e+00 -1.8649938272758655e+00 + 60 -2.0326029067319982e+00 -5.2224816026297454e+00 -2.6126651787431214e+00 + 61 -3.8509493120844207e-01 1.9073567822120387e+00 -7.1625738088539748e-01 + 62 -2.6004175741382847e+00 2.4418292628003133e+00 -2.1615478367945307e+00 + 63 1.6782508781720011e+00 -3.0101538006831734e+00 -7.1986308169233931e-02 + 64 2.2749536899334073e+00 2.5303495677814198e+00 6.0668040667204064e+00 +... From 1f75740de7045d2b355691d3f2eb8d7386d1699d Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sat, 2 Jul 2022 18:32:23 -0400 Subject: [PATCH 516/585] add unit test input for hybrid twobody/threebody sw style --- .../tests/manybody-pair-sw_twobody.yaml | 1 - .../tests/manybody-pair-sw_twothree.yaml | 157 ++++++++++++++++++ 2 files changed, 157 insertions(+), 1 deletion(-) create mode 100644 unittest/force-styles/tests/manybody-pair-sw_twothree.yaml diff --git a/unittest/force-styles/tests/manybody-pair-sw_twobody.yaml b/unittest/force-styles/tests/manybody-pair-sw_twobody.yaml index 42d3cebf81..0c48d47137 100644 --- a/unittest/force-styles/tests/manybody-pair-sw_twobody.yaml +++ b/unittest/force-styles/tests/manybody-pair-sw_twobody.yaml @@ -1,6 +1,5 @@ --- lammps_version: 23 Jun 2022 -tags: generated date_generated: Sat Jul 2 17:42:21 2022 epsilon: 1e-10 skip_tests: diff --git a/unittest/force-styles/tests/manybody-pair-sw_twothree.yaml b/unittest/force-styles/tests/manybody-pair-sw_twothree.yaml new file mode 100644 index 0000000000..68faad2b8b --- /dev/null +++ b/unittest/force-styles/tests/manybody-pair-sw_twothree.yaml @@ -0,0 +1,157 @@ +--- +lammps_version: 23 Jun 2022 +date_generated: Sat Jul 2 18:29:21 2022 +epsilon: 1e-10 +skip_tests: +prerequisites: ! | + pair sw +pre_commands: ! | + variable newton_pair delete + variable newton_pair index on +post_commands: ! "" +input_file: in.manybody +pair_style: hybrid sw threebody on sw threebody off +pair_coeff: ! | + * * sw 1 Si.sw Si Si Si Si NULL NULL NULL NULL + * 5*8 sw 2 Si.sw Si Si Si Si Si Si Si Si +extract: ! "" +natoms: 64 +init_vdwl: -258.5086399744112 +init_coul: 0 +init_stress: ! |2- + 6.4784606418926112e+00 8.9666260111962721e+00 1.6564019181847929e+01 -4.9679178424853108e+00 3.4388958502311766e+01 7.5390085880741020e-01 +init_forces: ! |2 + 1 -7.5117950925001176e-01 3.0512035938320858e+00 1.7548369060319566e+00 + 2 -2.5839943840157309e+00 -6.2407030855217227e-01 -2.0776063043672743e+00 + 3 6.4874626526431012e-01 -1.9191097130277632e-01 -2.8953907507029547e-01 + 4 -1.8780621642391011e+00 2.9563493639933633e+00 6.0045000947943949e-01 + 5 -1.3527836952861756e+00 -7.5563316408513048e-01 -4.0171785277050776e-01 + 6 3.0261027539317009e-01 3.3010495375946016e+00 1.0578432546004755e+00 + 7 -1.0220792530722718e+00 -8.9704171544868350e-01 2.2679286915120240e+00 + 8 7.3786854090375081e-02 6.8184832716858157e-01 -9.9742395408331985e-01 + 9 1.5404185888294175e-01 -2.4234656392100611e+00 -2.5547421022333259e+00 + 10 2.9152004537455556e-01 -1.3832499266817839e+00 -2.3112314079357352e+00 + 11 3.0397941652061906e+00 -3.2696818086953119e+00 2.0402858501197878e+00 + 12 -5.2427766862019523e+00 -2.9266230951551324e+00 -2.3274249447095405e+00 + 13 -3.4764983756087076e-01 5.1759636691465873e+00 -9.5777981490571462e-01 + 14 -1.3994974411693033e+00 3.6723581318644940e+00 4.9022891744156372e-01 + 15 -3.6451950102391031e+00 4.1804831124641391e+00 -2.3094319497556559e+00 + 16 1.7762576801244845e+00 -1.7769734947711072e-01 5.6118226682874788e+00 + 17 1.1626295956924018e+00 2.5434335885879951e+00 -4.1298909753889967e+00 + 18 2.6370967308167081e-01 4.8174395544262394e-01 3.2879300848711188e+00 + 19 -1.2180668170296169e+00 -2.0218982136836656e+00 -3.8444674827692210e-01 + 20 -6.1734234441618661e+00 -8.7047552939678141e-02 7.4088977580926274e-01 + 21 2.2527604735738231e+00 9.2512650808085084e-01 -2.7596546519202407e+00 + 22 -5.0794028512678571e+00 3.2609137644938517e+00 -3.9745643191135742e+00 + 23 1.8924999787954402e+00 3.3526647080652703e+00 1.2248568956854238e+00 + 24 1.5743771798508370e+00 1.3293691279058382e+00 2.6631027667815861e+00 + 25 8.3110919554353102e-01 -1.1460141213930673e-01 1.4368370342964809e+00 + 26 -4.7991049590854340e-01 -6.7362488036409351e-01 1.2327946774343894e+00 + 27 1.9900570741156840e+00 -5.0620387120655386e-01 1.5762394195123659e+00 + 28 5.7701286079972869e-01 1.3187742380597833e+00 4.1298244053155067e+00 + 29 -3.0416482921788530e+00 9.1958118398971411e-01 -1.1418981151511567e+00 + 30 -1.5986340571260498e+00 1.2172058599377520e+00 -8.9839567436920520e-01 + 31 -1.6221367664137194e+00 1.4053388522714974e+00 -4.1030835758060596e-01 + 32 -3.3999213065003993e+00 5.4646623792746152e-01 -4.9970596852221305e-01 + 33 4.3374523080961529e+00 -2.0526192390847209e+00 2.7863621822774500e+00 + 34 3.6899967841270293e-01 -9.7647299317203395e-02 3.7849093017581542e-01 + 35 1.2474956459695270e+00 -1.6786310914897268e-01 2.5255688468043052e+00 + 36 1.9423002050769304e-02 -2.5811032787101440e+00 -5.3464409483951571e-02 + 37 -1.7991755427583054e+00 1.7326288527074167e+00 -2.3172591544605829e+00 + 38 -2.6635345675769728e-01 -4.5619472453099841e-01 2.9146619578940203e-01 + 39 2.2040425723147274e+00 -1.2990665525340543e+00 -4.1031233229148558e+00 + 40 3.8636879669801210e+00 -1.9428932057790562e+00 -1.2090029697953577e+00 + 41 6.9184862237524403e-02 -5.5563025877752559e-01 -1.0104421056432389e+00 + 42 -4.1077204863643084e+00 -1.9092260113246491e+00 -2.7778884595397102e-01 + 43 6.9234276922332216e-01 -5.1959961010562941e+00 -3.8252772225624965e-01 + 44 3.1974368019347907e+00 -3.7333126721157721e+00 1.1927602690968555e+00 + 45 -1.0979421463666958e+00 1.4281871410588294e+00 -2.7844688870636198e+00 + 46 -2.3123927283410217e-01 -1.6246499267294727e+00 4.6068188624710249e+00 + 47 2.4575638270171472e+00 1.3529111936752540e+00 8.5779610605164602e-01 + 48 1.3053149069961458e+00 5.5515699432490606e-01 -3.4671208564970524e-01 + 49 -1.6274632987918134e+00 -4.7057286351454106e+00 -2.4249279782812714e+00 + 50 5.4224455439262353e-03 2.9897586979430182e+00 -1.3950914387971656e+00 + 51 -1.2459066473548797e+00 2.9456460712366872e+00 3.7288916669729959e+00 + 52 4.2616245425615027e+00 -4.4802874559509265e+00 4.4417404910060432e+00 + 53 2.7936251596841610e+00 2.8362368635929394e+00 1.5493162393308042e+00 + 54 2.4623429186012760e+00 -2.8582750315396499e+00 -1.7184511417663617e+00 + 55 8.8879734150460621e-01 -2.9956850724190431e+00 -3.5690867805221691e+00 + 56 -4.2180992335342188e-01 2.9462851508525667e-01 -2.1026878944189669e+00 + 57 1.9534125277666264e-01 -1.1222033415899244e+00 -3.0127694733977195e-01 + 58 2.7751167493305635e+00 -9.6251009716841907e-01 1.2847140239740573e+00 + 59 2.7332664162886871e+00 1.6874002693437411e+00 -1.8630367163899653e+00 + 60 -1.9920742303178280e+00 -5.1976595137487056e+00 -2.5715712256855774e+00 + 61 -3.9186643718089481e-01 1.8941052818415300e+00 -7.2852310082079819e-01 + 62 -2.6017296078018801e+00 2.4477411514482652e+00 -2.1740532348808843e+00 + 63 1.6751774499211569e+00 -2.9786131173037518e+00 -4.4746311293689334e-02 + 64 2.2350712682686358e+00 2.4856397598318183e+00 6.0442073184431804e+00 +run_vdwl: -258.49958453100083 +run_coul: 0 +run_stress: ! |2- + 6.4308197607512207e+00 8.9800199663285003e+00 1.6644361563236384e+01 -5.0072799407290933e+00 3.4219821356106827e+01 1.0492826840671752e+00 +run_forces: ! |2 + 1 -7.5937225945190234e-01 3.0453338820624740e+00 1.7588997466292104e+00 + 2 -2.5842358982706335e+00 -6.4961465564215615e-01 -2.0836136472867430e+00 + 3 6.1692053064567098e-01 -1.7923404289169326e-01 -2.5776384969855004e-01 + 4 -1.8642434203060627e+00 2.9689111967459501e+00 5.7860631771685955e-01 + 5 -1.3707214670175798e+00 -7.6882987771621170e-01 -3.8201327706454102e-01 + 6 3.5155029154762341e-01 3.3059375310476078e+00 1.0816937673465203e+00 + 7 -1.0031791908375163e+00 -8.6956258364196903e-01 2.2425245701241256e+00 + 8 5.9471905500534855e-02 6.7712638453480301e-01 -9.9455163342971664e-01 + 9 1.3241459971867986e-01 -2.4451165560724939e+00 -2.5688790544877764e+00 + 10 2.7987758741645180e-01 -1.3869445825984155e+00 -2.2737317048352144e+00 + 11 3.0093494239500198e+00 -3.2460329093479796e+00 2.0365059310692528e+00 + 12 -5.2407962483722299e+00 -2.9126882828373892e+00 -2.3181917992781393e+00 + 13 -2.9313171711099439e-01 5.1682815536825712e+00 -9.3178794843042834e-01 + 14 -1.4205609886004000e+00 3.6728355746142340e+00 4.7973399106847658e-01 + 15 -3.6438539671591443e+00 4.1738585973197599e+00 -2.2995365264114183e+00 + 16 1.7665430073015751e+00 -1.6683625231758512e-01 5.5980371264386779e+00 + 17 1.1609247141613361e+00 2.5445069687633297e+00 -4.1101937186844282e+00 + 18 2.3250564926703476e-01 5.0119516573698042e-01 3.2999642189792335e+00 + 19 -1.2455755116140015e+00 -2.0483645027853901e+00 -3.9915953456528291e-01 + 20 -6.1533476323819176e+00 -1.0336110065476101e-01 7.2207408198501200e-01 + 21 2.2580812272923181e+00 8.8665782626079470e-01 -2.7867801726837302e+00 + 22 -5.0715437260287493e+00 3.2720805913066657e+00 -3.9870515109961557e+00 + 23 1.9067384153660658e+00 3.3666024181351721e+00 1.2360966484469924e+00 + 24 1.6076366668181858e+00 1.3129049141466480e+00 2.6481286770383776e+00 + 25 8.2849608748715486e-01 -1.0946573630945597e-01 1.4137379100581711e+00 + 26 -4.9245162995242892e-01 -6.5633188499443507e-01 1.2397189435323859e+00 + 27 2.0002065581614117e+00 -5.2635572637485362e-01 1.5812234025897816e+00 + 28 5.6469856770107940e-01 1.3419655834852620e+00 4.1390158667617349e+00 + 29 -3.0414702840545953e+00 9.2717141811819714e-01 -1.1446412927789829e+00 + 30 -1.5780449202280824e+00 1.1972994610432426e+00 -9.0937832538133057e-01 + 31 -1.6135468935693842e+00 1.4097747955859368e+00 -4.1013831752390606e-01 + 32 -3.3839861094059622e+00 5.3294244523702139e-01 -5.1150418397474551e-01 + 33 4.3179202422054441e+00 -2.0530236039826488e+00 2.7909047875298785e+00 + 34 3.6044667063424402e-01 -9.6636899664461151e-02 3.8719887922396817e-01 + 35 1.2574806392912077e+00 -1.5474474915574327e-01 2.5284696614857665e+00 + 36 -9.2507293281699435e-03 -2.5688826605251358e+00 -8.8917022692736422e-02 + 37 -1.7874734690551621e+00 1.7150271178623466e+00 -2.3271057624984728e+00 + 38 -2.4661620491429920e-01 -4.4857619628292789e-01 3.0090275228821284e-01 + 39 2.1876463817081504e+00 -1.2953665685720137e+00 -4.1070251548877099e+00 + 40 3.8954619284501790e+00 -1.9483835119233022e+00 -1.2227531289487130e+00 + 41 9.7565025130134986e-02 -5.2646053136013171e-01 -9.8280124384883216e-01 + 42 -4.1063684977228627e+00 -1.9251952046358491e+00 -2.9901720087297745e-01 + 43 6.7939692719606781e-01 -5.1874569217896553e+00 -3.9562141806867668e-01 + 44 3.2038887558519624e+00 -3.7312345150848865e+00 1.1791192854681274e+00 + 45 -1.1219574440264011e+00 1.4017870123386453e+00 -2.7737869798443744e+00 + 46 -2.3209294883240861e-01 -1.6182897275509909e+00 4.6296975808382292e+00 + 47 2.4602350215523230e+00 1.3452019889417968e+00 8.6358301807951909e-01 + 48 1.3093376440442195e+00 5.7371015819454974e-01 -3.5578408565068542e-01 + 49 -1.6696474765984912e+00 -4.7474039477977534e+00 -2.4607694981777111e+00 + 50 1.2989593641085762e-02 2.9812087098985032e+00 -1.4123464138675532e+00 + 51 -1.2853374902017072e+00 2.9768731587433566e+00 3.7403754374802136e+00 + 52 4.2768627438095717e+00 -4.4665207635060362e+00 4.4526942886425624e+00 + 53 2.8263576162367916e+00 2.8711821643474851e+00 1.6198032393140251e+00 + 54 2.4557393026757937e+00 -2.8576870371250473e+00 -1.7106753514157176e+00 + 55 8.7016650440838128e-01 -2.9993943594233770e+00 -3.5406400607258579e+00 + 56 -4.2720269240408387e-01 2.6284724466018883e-01 -2.0965871396618163e+00 + 57 1.8938909101993043e-01 -1.1500277319075998e+00 -3.0413618657653302e-01 + 58 2.7772395410738175e+00 -9.4351277181421511e-01 1.2588196612829905e+00 + 59 2.7573808001442890e+00 1.7074123239008328e+00 -1.8649940082533623e+00 + 60 -2.0326029067319991e+00 -5.2224816026297418e+00 -2.6126651787431188e+00 + 61 -3.8509493124293104e-01 1.9073567822530930e+00 -7.1625738092917579e-01 + 62 -2.6004175741383238e+00 2.4418292628003044e+00 -2.1615478367946075e+00 + 63 1.6782508782162848e+00 -3.0101538006328594e+00 -7.1986308168993651e-02 + 64 2.2749536899334060e+00 2.5303495677814132e+00 6.0668040667204073e+00 +... From 6f3f1dba6e3f2b05c3d68ad94ff81a73177d270f Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sat, 2 Jul 2022 19:05:58 -0400 Subject: [PATCH 517/585] more documentation tweaks --- doc/src/pair_sw.rst | 55 +++++++++++++++++++++++++++------------------ 1 file changed, 33 insertions(+), 22 deletions(-) diff --git a/doc/src/pair_sw.rst b/doc/src/pair_sw.rst index b2305dab5e..c456b2f422 100644 --- a/doc/src/pair_sw.rst +++ b/doc/src/pair_sw.rst @@ -134,15 +134,17 @@ three-body term of the potential is calculated. The default value is but not available for the *sw/mod* and :doc:`sw/angle/table ` pair style variants. To turn off the threebody contributions all :math:`\lambda_{ijk}` parameters from the potential -file are forcibly set to 0. In addition the pair style implementations +file are forcibly set to 0. In addition the pair style implementation may employ code optimizations for the *threebody off* setting that can -result in significant speedups versus the default. +result in significant speedups versus the default. These code optimizations +are currently only available for the MANYBODY and OPENMP packages. -Only a single pair_coeff command is used with the *sw* and *sw/mod* styles -which specifies a Stillinger-Weber potential file with parameters for all -needed elements. These are mapped to LAMMPS atom types by specifying -N additional arguments after the filename in the pair_coeff command, -where N is the number of LAMMPS atom types: +Only a single pair_coeff command is used with the *sw* and *sw/mod* +styles which specifies a Stillinger-Weber potential file with parameters +for all needed elements, except for when the *threebody off* setting is +used (see note below). These are mapped to LAMMPS atom types by +specifying N additional arguments after the filename in the pair_coeff +command, where N is the number of LAMMPS atom types: * filename * N element names = mapping of SW elements to atom types @@ -157,20 +159,20 @@ pair_coeff command: .. code-block:: LAMMPS + pair_style sw pair_coeff * * SiC.sw Si Si Si C The first 2 arguments must be \* \* so as to span all LAMMPS atom types. -The first three Si arguments map LAMMPS atom types 1,2,3 to the Si -element in the SW file. The final C argument maps LAMMPS atom type 4 -to the C element in the SW file. If a mapping value is specified as -NULL, the mapping is not performed. This can be used when a *sw* +The first three Si arguments map LAMMPS atom types 1, 2, and 3 to the Si +element in the SW file. The final C argument maps LAMMPS atom type 4 to +the C element in the SW file. If an argument value is specified as +NULL, the mapping is not performed. This can be used when an *sw* potential is used as part of the *hybrid* pair style. The NULL values -are placeholders for atom types that will be used with other -potentials. +are placeholders for atom types that will be used with other potentials. .. note:: - When the *skip_threebody on* keyword is used, multiple pair_coeff commands may + When the *threebody off* keyword is used, multiple pair_coeff commands may be used to specific the pairs of atoms which don't require three-body term. In these cases, the first 2 arguments are not required to be \* \*. @@ -276,30 +278,39 @@ described above from values in the potential file. This pair style does not support the :doc:`pair_modify ` shift, table, and tail options. -This pair style does not write its information to :doc:`binary restart files `, since it is stored in potential files. Thus, you -need to re-specify the pair_style and pair_coeff commands in an input -script that reads a restart file. +This pair style does not write its information to :doc:`binary restart +files `, since it is stored in potential files. Thus, you need +to re-specify the pair_style and pair_coeff commands in an input script +that reads a restart file. This pair style can only be used via the *pair* keyword of the :doc:`run_style respa ` command. It does not support the *inner*, *middle*, *outer* keywords. +The single() function of the *sw* pair style is only enabled and +supported for the case of the *threebody off* setting. + ---------- Restrictions """""""""""" -This pair style is part of the MANYBODY package. It is only enabled -if LAMMPS was built with that package. See the :doc:`Build package ` page for more info. +This pair style is part of the MANYBODY package. It is only enabled if +LAMMPS was built with that package. See the :doc:`Build package +` page for more info. This pair style requires the :doc:`newton ` setting to be "on" for pair interactions. The Stillinger-Weber potential files provided with LAMMPS (see the potentials directory) are parameterized for metal :doc:`units `. -You can use the SW potential with any LAMMPS units, but you would need -to create your own SW potential file with coefficients listed in the -appropriate units if your simulation does not use "metal" units. +You can use the sw or sw/mod pair styles with any LAMMPS units, but you +would need to create your own SW potential file with coefficients listed +in the appropriate units if your simulation does not use "metal" units. +If the potential file contains a 'UNITS:' metadata tag in the first line +of the potential file, then LAMMPS can convert it transparently between +"metal" and "real" units. + Related commands """""""""""""""" From ea48b031a48fad37537cf9f247618f48d9b3ae08 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sat, 2 Jul 2022 21:24:25 -0400 Subject: [PATCH 518/585] must not run hybrid styles with GPU package that use the same pair style twice --- unittest/force-styles/tests/manybody-pair-sw_twothree.yaml | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/unittest/force-styles/tests/manybody-pair-sw_twothree.yaml b/unittest/force-styles/tests/manybody-pair-sw_twothree.yaml index 68faad2b8b..0a7c60a892 100644 --- a/unittest/force-styles/tests/manybody-pair-sw_twothree.yaml +++ b/unittest/force-styles/tests/manybody-pair-sw_twothree.yaml @@ -2,7 +2,7 @@ lammps_version: 23 Jun 2022 date_generated: Sat Jul 2 18:29:21 2022 epsilon: 1e-10 -skip_tests: +skip_tests: gpu prerequisites: ! | pair sw pre_commands: ! | From 886d95c32dc50162d6a169ef6310fe5b8e7a04c6 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sat, 2 Jul 2022 22:25:11 -0400 Subject: [PATCH 519/585] clang-tidy fixes --- src/AMOEBA/amoeba_convolution.cpp | 8 +-- src/AMOEBA/amoeba_file.cpp | 94 ++++++++++++------------ src/AMOEBA/angle_amoeba.cpp | 2 +- src/AMOEBA/atom_vec_amoeba.cpp | 2 +- src/AMOEBA/fix_amoeba_bitorsion.h | 66 ++++++++--------- src/AMOEBA/fix_amoeba_pitorsion.cpp | 2 +- src/AMOEBA/improper_amoeba.cpp | 2 +- src/AMOEBA/pair_amoeba.cpp | 106 ++++++++++++++-------------- src/AMOEBA/pair_amoeba.h | 34 ++++----- src/fix_store.cpp | 6 +- src/pair_hybrid.h | 2 +- src/special.cpp | 2 +- 12 files changed, 163 insertions(+), 163 deletions(-) diff --git a/src/AMOEBA/amoeba_convolution.cpp b/src/AMOEBA/amoeba_convolution.cpp index 9c8f728f99..ea6b9d5293 100644 --- a/src/AMOEBA/amoeba_convolution.cpp +++ b/src/AMOEBA/amoeba_convolution.cpp @@ -228,12 +228,12 @@ AmoebaConvolution::AmoebaConvolution(LAMMPS *lmp, Pair *pair, memory->create3d_offset(grid_brick,nzlo_out,nzhi_out,nylo_out,nyhi_out, nxlo_out,nxhi_out,"amoeba:grid_brick"); grid_brick_start = &grid_brick[nzlo_out][nylo_out][nxlo_out]; - cgrid_brick = NULL; + cgrid_brick = nullptr; } else { memory->create4d_offset_last(cgrid_brick,nzlo_out,nzhi_out,nylo_out,nyhi_out, nxlo_out,nxhi_out,2,"amoeba:cgrid_brick"); grid_brick_start = &cgrid_brick[nzlo_out][nylo_out][nxlo_out][0]; - grid_brick = NULL; + grid_brick = nullptr; } memory->create(grid_fft,ngrid_either,"amoeba:grid_fft"); @@ -283,7 +283,7 @@ void *AmoebaConvolution::zero() void *AmoebaConvolution::zero_3d() { - if (!grid_brick) return NULL; + if (!grid_brick) return nullptr; memset(&(grid_brick[nzlo_out][nylo_out][nxlo_out]),0, nbrick_ghosts*sizeof(FFT_SCALAR)); return (void *) grid_brick; @@ -293,7 +293,7 @@ void *AmoebaConvolution::zero_3d() void *AmoebaConvolution::zero_4d() { - if (!cgrid_brick) return NULL; + if (!cgrid_brick) return nullptr; memset(&(cgrid_brick[nzlo_out][nylo_out][nxlo_out][0]),0, 2*nbrick_ghosts*sizeof(FFT_SCALAR)); return (void *) cgrid_brick; diff --git a/src/AMOEBA/amoeba_file.cpp b/src/AMOEBA/amoeba_file.cpp index dc37eff756..9359e5711c 100644 --- a/src/AMOEBA/amoeba_file.cpp +++ b/src/AMOEBA/amoeba_file.cpp @@ -85,7 +85,7 @@ void PairAmoeba::read_prmfile(char *filename) if (me == 0) { fptr = utils::open_potential(filename,lmp,nullptr); - if (fptr == NULL) { + if (fptr == nullptr) { char str[128]; snprintf(str,128,"Cannot open AMOEBA PRM file %s",filename); error->one(FLERR,str); @@ -102,7 +102,7 @@ void PairAmoeba::read_prmfile(char *filename) int atomtype_flag = 0; int section; - while (1) { + while (true) { if (me == 0) n = read_section_name(fptr,line); MPI_Bcast(&n,1,MPI_INT,0,world); if (n < 0) break; @@ -148,7 +148,7 @@ void PairAmoeba::read_prmfile(char *filename) nextflag = 0; - while (1) { + while (true) { if (me == 0) n = read_section_line(fptr,line,nextflag,next); MPI_Bcast(&n,1,MPI_INT,0,world); if (n < 0) break; @@ -264,7 +264,7 @@ void PairAmoeba::read_keyfile(char *filename) char line[MAXLINE]; if (me == 0) { fptr = utils::open_potential(filename,lmp,nullptr); - if (fptr == NULL) + if (fptr == nullptr) error->one(FLERR,"Cannot open AMOEBA key file {}: {}",filename, utils::getsyserror()); } @@ -273,7 +273,7 @@ void PairAmoeba::read_keyfile(char *filename) int n; char *ptr,*keyword; - while (1) { + while (true) { if (me == 0) { ptr = fgets(line,MAXLINE,fptr); if (!ptr) n = -1; @@ -556,7 +556,7 @@ int PairAmoeba::read_section_name(FILE *fp, char *line) char **words; int nwords; - while (1) { + while (true) { ptr = fgets(line,MAXLINE,fp); if (!ptr) return -1; if (strspn(line," \t\n\r") == strlen(line)) continue; @@ -612,10 +612,10 @@ int PairAmoeba::read_section_line(FILE *fp, char *line, char **words,**words_next; int nwords, nwords_next; - copy = copy_next = NULL; - words = words_next = NULL; + copy = copy_next = nullptr; + words = words_next = nullptr; - while (1) { + while (true) { if (nextflag) { strcpy(line,next); nextflag = 0; @@ -634,11 +634,11 @@ int PairAmoeba::read_section_line(FILE *fp, char *line, if (strstr(words[0],"#") || strstr(words[0],"!!") || !isalpha(words[0][0])) { delete[] words; delete[] copy; - words = NULL; - copy = NULL; + words = nullptr; + copy = nullptr; continue; } - while (1) { + while (true) { ptr = fgets(next,MAXLINE,fp); if (!ptr) { nextflag = 0; @@ -1236,48 +1236,48 @@ void PairAmoeba::initialize_type_class() // per type data - amtype_defined = NULL; - amtype2class = NULL; - atomic_num = NULL; - valence = NULL; - am_mass = NULL; - am_q = NULL; - am_mu = NULL; - npolgroup = NULL; - polgroup = NULL; - polarity = NULL; - pdamp = NULL; - thole = NULL; - dirdamp = NULL; - sizpr = NULL; - dmppr = NULL; - elepr = NULL; + amtype_defined = nullptr; + amtype2class = nullptr; + atomic_num = nullptr; + valence = nullptr; + am_mass = nullptr; + am_q = nullptr; + am_mu = nullptr; + npolgroup = nullptr; + polgroup = nullptr; + polarity = nullptr; + pdamp = nullptr; + thole = nullptr; + dirdamp = nullptr; + sizpr = nullptr; + dmppr = nullptr; + elepr = nullptr; - nmultiframe = NULL; - mpaxis = NULL; - xpole = NULL; - ypole = NULL; - zpole = NULL; - fpole = NULL; + nmultiframe = nullptr; + mpaxis = nullptr; + xpole = nullptr; + ypole = nullptr; + zpole = nullptr; + fpole = nullptr; // per class data - amclass_defined = NULL; - vdwl_eps = NULL; - vdwl_sigma = NULL; - kred = NULL; - csix = NULL; - adisp = NULL; - chgct = NULL; - dmpct = NULL; - pcore = NULL; - palpha = NULL; + amclass_defined = nullptr; + vdwl_eps = nullptr; + vdwl_sigma = nullptr; + kred = nullptr; + csix = nullptr; + adisp = nullptr; + chgct = nullptr; + dmpct = nullptr; + pcore = nullptr; + palpha = nullptr; // other - vdwl_class_pair = NULL; - vdwl_sigma_pair = NULL; - vdwl_eps_pair = NULL; + vdwl_class_pair = nullptr; + vdwl_sigma_pair = nullptr; + vdwl_eps_pair = nullptr; } /* ---------------------------------------------------------------------- diff --git a/src/AMOEBA/angle_amoeba.cpp b/src/AMOEBA/angle_amoeba.cpp index ca32d37fe3..1376dbcd5c 100644 --- a/src/AMOEBA/angle_amoeba.cpp +++ b/src/AMOEBA/angle_amoeba.cpp @@ -697,7 +697,7 @@ void AngleAmoeba::init_style() { // check if PairAmoeba or PairHippo disabled angle or Urey-Bradley terms - Pair *pair = NULL; + Pair *pair = nullptr; pair = force->pair_match("amoeba",1,0); if (!pair) pair = force->pair_match("hippo",1,0); diff --git a/src/AMOEBA/atom_vec_amoeba.cpp b/src/AMOEBA/atom_vec_amoeba.cpp index b84ca7ab1e..eb6935a9dd 100644 --- a/src/AMOEBA/atom_vec_amoeba.cpp +++ b/src/AMOEBA/atom_vec_amoeba.cpp @@ -62,7 +62,7 @@ AtomVecAmoeba::AtomVecAmoeba(LAMMPS *lmp) : AtomVec(lmp) setup_fields(); bond_per_atom = angle_per_atom = dihedral_per_atom = improper_per_atom = 0; - bond_negative = angle_negative = dihedral_negative = improper_negative = NULL; + bond_negative = angle_negative = dihedral_negative = improper_negative = nullptr; } /* ---------------------------------------------------------------------- */ diff --git a/src/AMOEBA/fix_amoeba_bitorsion.h b/src/AMOEBA/fix_amoeba_bitorsion.h index d401f864bd..2a94891d03 100644 --- a/src/AMOEBA/fix_amoeba_bitorsion.h +++ b/src/AMOEBA/fix_amoeba_bitorsion.h @@ -27,51 +27,51 @@ class FixAmoebaBiTorsion : public Fix { public: FixAmoebaBiTorsion(class LAMMPS *, int, char **); ~FixAmoebaBiTorsion(); - int setmask(); - void init(); - void setup(int); - void setup_pre_neighbor(); - void setup_pre_reverse(int, int); - void min_setup(int); - void pre_neighbor(); - void pre_reverse(int, int); - void post_force(int); - void post_force_respa(int, int, int); - void min_post_force(int); - double compute_scalar(); + int setmask() override; + void init() override; + void setup(int) override; + void setup_pre_neighbor() override; + void setup_pre_reverse(int, int) override; + void min_setup(int) override; + void pre_neighbor() override; + void pre_reverse(int, int) override; + void post_force(int) override; + void post_force_respa(int, int, int) override; + void min_post_force(int) override; + double compute_scalar() override; - void read_data_header(char *); - void read_data_section(char *, int, char *, tagint); - bigint read_data_skip_lines(char *); - void write_data_header(FILE *, int); - void write_data_section_size(int, int &, int &); - void write_data_section_pack(int, double **); - void write_data_section_keyword(int, FILE *); - void write_data_section(int, FILE *, int, double **, int); + void read_data_header(char *) override; + void read_data_section(char *, int, char *, tagint) override; + bigint read_data_skip_lines(char *) override; + void write_data_header(FILE *, int) override; + void write_data_section_size(int, int &, int &) override; + void write_data_section_pack(int, double **) override; + void write_data_section_keyword(int, FILE *) override; + void write_data_section(int, FILE *, int, double **, int) override; - void write_restart(FILE *); - void restart(char *); - int pack_restart(int, double *); - void unpack_restart(int, int); - int size_restart(int); - int maxsize_restart(); + void write_restart(FILE *) override; + void restart(char *) override; + int pack_restart(int, double *) override; + void unpack_restart(int, int) override; + int size_restart(int) override; + int maxsize_restart() override; - void grow_arrays(int); - void copy_arrays(int, int, int); - void set_arrays(int); + void grow_arrays(int) override; + void copy_arrays(int, int, int) override; + void set_arrays(int) override; int pack_border(int, int *, double *) override; int unpack_border(int, int, double *) override; - int pack_exchange(int, double *); - int unpack_exchange(int, double *); + int pack_exchange(int, double *) override; + int unpack_exchange(int, double *) override; - double memory_usage(); + double memory_usage() override; private: int nprocs, me; int eflag_caller; int ilevel_respa; int disable; - bigint nbitorsions; // total count of all bitorsions in system + bigint nbitorsions; // total count of all bitorsions in system double ebitorsion; double onefifth; diff --git a/src/AMOEBA/fix_amoeba_pitorsion.cpp b/src/AMOEBA/fix_amoeba_pitorsion.cpp index 967972fad7..e5c19b43c2 100644 --- a/src/AMOEBA/fix_amoeba_pitorsion.cpp +++ b/src/AMOEBA/fix_amoeba_pitorsion.cpp @@ -152,7 +152,7 @@ void FixAmoebaPiTorsion::init() // check if PairAmoeba or PairHippo disabled pitorsion terms - Pair *pair = NULL; + Pair *pair = nullptr; pair = force->pair_match("amoeba",1,0); if (!pair) pair = force->pair_match("hippo",1,0); diff --git a/src/AMOEBA/improper_amoeba.cpp b/src/AMOEBA/improper_amoeba.cpp index 2b39214642..df3a6584cf 100644 --- a/src/AMOEBA/improper_amoeba.cpp +++ b/src/AMOEBA/improper_amoeba.cpp @@ -284,7 +284,7 @@ void ImproperAmoeba::init_style() { // check if PairAmoeba disabled improper terms - Pair *pair = NULL; + Pair *pair = nullptr; pair = force->pair_match("amoeba",1,0); if (!pair) pair = force->pair_match("hippo",1,0); if (!pair) error->all(FLERR,"Improper amoeba could not find pair amoeba/hippo"); diff --git a/src/AMOEBA/pair_amoeba.cpp b/src/AMOEBA/pair_amoeba.cpp index dcbd3ab556..9d6695a6e0 100644 --- a/src/AMOEBA/pair_amoeba.cpp +++ b/src/AMOEBA/pair_amoeba.cpp @@ -68,67 +68,67 @@ PairAmoeba::PairAmoeba(LAMMPS *lmp) : Pair(lmp) // force field settings nmax = 0; - xaxis2local = yaxis2local = zaxis2local = NULL; - rpole = NULL; - tq = NULL; + xaxis2local = yaxis2local = zaxis2local = nullptr; + rpole = nullptr; + tq = nullptr; - red2local = NULL; - xred = NULL; + red2local = nullptr; + xred = nullptr; - uind = uinp = udirp = NULL; - uopt = uoptp = NULL; - fopt = foptp = NULL; - field = fieldp = NULL; - ufld = dufld = NULL; - rsd = rsdp = NULL; - zrsd = zrsdp = NULL; + uind = uinp = udirp = nullptr; + uopt = uoptp = nullptr; + fopt = foptp = nullptr; + field = fieldp = nullptr; + ufld = dufld = nullptr; + rsd = rsdp = nullptr; + zrsd = zrsdp = nullptr; - cmp = fmp = NULL; - cphi = fphi = NULL; + cmp = fmp = nullptr; + cphi = fphi = nullptr; - poli = NULL; - conj = conjp = NULL; - vec = vecp = NULL; - udir = usum = usump = NULL; + poli = nullptr; + conj = conjp = nullptr; + vec = vecp = nullptr; + udir = usum = usump = nullptr; - fuind = fuinp = NULL; - fdip_phi1 = fdip_phi2 = fdip_sum_phi = NULL; - dipfield1 = dipfield2 = NULL; + fuind = fuinp = nullptr; + fdip_phi1 = fdip_phi2 = fdip_sum_phi = nullptr; + dipfield1 = dipfield2 = nullptr; - fphid = fphip = NULL; - fphidp = cphidp = NULL; + fphid = fphip = nullptr; + fphidp = cphidp = nullptr; bsordermax = 0; - thetai1 = thetai2 = thetai3 = NULL; - bsmod1 = bsmod2 = bsmod3 = NULL; - bsbuild = NULL; - igrid = NULL; - m_kspace = p_kspace = pc_kspace = d_kspace = NULL; - i_kspace = ic_kspace = NULL; + thetai1 = thetai2 = thetai3 = nullptr; + bsmod1 = bsmod2 = bsmod3 = nullptr; + bsbuild = nullptr; + igrid = nullptr; + m_kspace = p_kspace = pc_kspace = d_kspace = nullptr; + i_kspace = ic_kspace = nullptr; - numneigh_dipole = NULL; - firstneigh_dipole = NULL; - firstneigh_dipdip = NULL; - ipage_dipole = NULL; - dpage_dipdip = NULL; + numneigh_dipole = nullptr; + firstneigh_dipole = nullptr; + firstneigh_dipdip = nullptr; + ipage_dipole = nullptr; + dpage_dipdip = nullptr; - numneigh_precond = NULL; - firstneigh_precond = NULL; - ipage_precond = NULL; + numneigh_precond = nullptr; + firstneigh_precond = nullptr; + ipage_precond = nullptr; - firstneigh_pcpc = NULL; - dpage_pcpc = NULL; + firstneigh_pcpc = nullptr; + dpage_pcpc = nullptr; - qfac = NULL; - gridfft1 = NULL; + qfac = nullptr; + gridfft1 = nullptr; initialize_type_class(); initialize_vdwl(); initialize_smallsize(); - forcefield = NULL; + forcefield = nullptr; - id_pole = id_udalt = id_upalt = NULL; + id_pole = id_udalt = id_upalt = nullptr; nualt = 0; first_flag = 1; @@ -640,7 +640,7 @@ void PairAmoeba::coeff(int narg, char **arg) set_defaults(); read_prmfile(arg[2]); - if (narg == 3) read_keyfile(NULL); + if (narg == 3) read_keyfile(nullptr); else read_keyfile(arg[3]); // compute Vdwl mixing rules, only for AMOEBA @@ -1574,7 +1574,7 @@ void PairAmoeba::assign_groups() int nstack = 0; int maxstack = 0; - int *stack = NULL; + int *stack = nullptr; tagint **special = atom->special; int **nspecial = atom->nspecial; @@ -1590,7 +1590,7 @@ void PairAmoeba::assign_groups() // loop until no ghost atom groupIDs are reset - while (1) { + while (true) { // loop over all atoms and their group neighborhoods @@ -1819,7 +1819,7 @@ void PairAmoeba::precond_neigh() void PairAmoeba::initialize_vdwl() { - radmin = radmin4 = epsilon = epsilon4 = NULL; + radmin = radmin4 = epsilon = epsilon4 = nullptr; } void PairAmoeba::allocate_vdwl() @@ -1844,12 +1844,12 @@ void PairAmoeba::deallocate_vdwl() void PairAmoeba::initialize_smallsize() { - copt = copm = NULL; - a_ualt = ap_ualt = NULL; - b_ualt = bp_ualt = NULL; - c_ualt = cp_ualt = NULL; - bpred = bpredp = bpreds = bpredps = NULL; - gear = aspc = NULL; + copt = copm = nullptr; + a_ualt = ap_ualt = nullptr; + b_ualt = bp_ualt = nullptr; + c_ualt = cp_ualt = nullptr; + bpred = bpredp = bpreds = bpredps = nullptr; + gear = aspc = nullptr; } void PairAmoeba::allocate_smallsize() diff --git a/src/AMOEBA/pair_amoeba.h b/src/AMOEBA/pair_amoeba.h index 1c3e738b4b..af760e275f 100644 --- a/src/AMOEBA/pair_amoeba.h +++ b/src/AMOEBA/pair_amoeba.h @@ -31,26 +31,26 @@ namespace LAMMPS_NS { class PairAmoeba : public Pair { public: PairAmoeba(class LAMMPS *); - ~PairAmoeba(); - void compute(int, int); - void settings(int, char **); - void coeff(int, char **); - void init_style(); - double init_one(int, int); - void finish(); + ~PairAmoeba() override; + void compute(int, int) override; + void settings(int, char **) override; + void coeff(int, char **) override; + void init_style() override; + double init_one(int, int) override; + void finish() override; - int pack_forward_comm(int, int *, double *, int, int *); - void unpack_forward_comm(int, int, double *); - int pack_reverse_comm(int, int, double *); - void unpack_reverse_comm(int, int *, double *); + int pack_forward_comm(int, int *, double *, int, int *) override; + void unpack_forward_comm(int, int, double *) override; + int pack_reverse_comm(int, int, double *) override; + void unpack_reverse_comm(int, int *, double *) override; - void pack_forward_grid(int, void *, int, int *); - void unpack_forward_grid(int, void *, int, int *); - void pack_reverse_grid(int, void *, int, int *); - void unpack_reverse_grid(int, void *, int, int *); + void pack_forward_grid(int, void *, int, int *) override; + void unpack_forward_grid(int, void *, int, int *) override; + void pack_reverse_grid(int, void *, int, int *) override; + void unpack_reverse_grid(int, void *, int, int *) override; - void *extract(const char *, int &); - double memory_usage(); + void *extract(const char *, int &) override; + double memory_usage() override; protected: int nmax; // allocation for owned+ghost diff --git a/src/fix_store.cpp b/src/fix_store.cpp index 9240270b02..a80c9b0b56 100644 --- a/src/fix_store.cpp +++ b/src/fix_store.cpp @@ -80,9 +80,9 @@ vstore(nullptr), astore(nullptr), rbuf(nullptr) nbytes = n2*n3 * sizeof(double); } - vstore = NULL; - astore = NULL; - tstore = NULL; + vstore = nullptr; + astore = nullptr; + tstore = nullptr; // allocate data struct and restart buffer rbuf // for PERATOM, register with Atom class diff --git a/src/pair_hybrid.h b/src/pair_hybrid.h index fdcd408ea7..e66cc4d3f6 100644 --- a/src/pair_hybrid.h +++ b/src/pair_hybrid.h @@ -46,7 +46,7 @@ class PairHybrid : public Pair { void init_style() override; double init_one(int, int) override; void setup() override; - void finish(); + void finish() override; void write_restart(FILE *) override; void read_restart(FILE *) override; double single(int, int, int, int, double, double, double, double &) override; diff --git a/src/special.cpp b/src/special.cpp index 4882b5752b..a7153b99d9 100644 --- a/src/special.cpp +++ b/src/special.cpp @@ -35,7 +35,7 @@ Special::Special(LAMMPS *lmp) : Pointers(lmp) MPI_Comm_rank(world,&me); MPI_Comm_size(world,&nprocs); - onetwo = onethree = onefour = onefive = NULL; + onetwo = onethree = onefour = onefive = nullptr; } /* ---------------------------------------------------------------------- */ From 3399e1d0d3e1b23e1fa14d75e2edca3b142ad1a8 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sun, 3 Jul 2022 06:53:03 -0400 Subject: [PATCH 520/585] add override parameters to overridden virtual functions --- src/AMOEBA/angle_amoeba.h | 20 +++++---- src/AMOEBA/atom_vec_amoeba.h | 14 +++---- src/AMOEBA/fix_amoeba_bitorsion.h | 4 +- src/AMOEBA/fix_amoeba_pitorsion.h | 67 +++++++++++++++---------------- src/AMOEBA/improper_amoeba.h | 16 ++++---- src/AMOEBA/pair_amoeba.h | 2 - src/AMOEBA/pair_hippo.h | 2 - 7 files changed, 56 insertions(+), 69 deletions(-) diff --git a/src/AMOEBA/angle_amoeba.h b/src/AMOEBA/angle_amoeba.h index 52376ff1a8..de9bd42ca5 100644 --- a/src/AMOEBA/angle_amoeba.h +++ b/src/AMOEBA/angle_amoeba.h @@ -27,15 +27,15 @@ namespace LAMMPS_NS { class AngleAmoeba : public Angle { public: AngleAmoeba(class LAMMPS *); - virtual ~AngleAmoeba(); - void compute(int, int); - void coeff(int, char **); - void init_style(); - double equilibrium_angle(int); - void write_restart(FILE *); - void read_restart(FILE *); - void write_data(FILE *); - double single(int, int, int, int); + ~AngleAmoeba() override; + void compute(int, int) override; + void coeff(int, char **) override; + void init_style() override; + double equilibrium_angle(int) override; + void write_restart(FILE *) override; + void read_restart(FILE *) override; + void write_data(FILE *) override; + double single(int, int, int, int) override; protected: int *pflag, *ubflag; @@ -52,8 +52,6 @@ class AngleAmoeba : public Angle { void tinker_urey_bradley(int, int, int, int); void allocate(); }; - } // namespace LAMMPS_NS - #endif #endif diff --git a/src/AMOEBA/atom_vec_amoeba.h b/src/AMOEBA/atom_vec_amoeba.h index cb1f76cae3..a80d4c4b61 100644 --- a/src/AMOEBA/atom_vec_amoeba.h +++ b/src/AMOEBA/atom_vec_amoeba.h @@ -27,13 +27,13 @@ namespace LAMMPS_NS { class AtomVecAmoeba : public AtomVec { public: AtomVecAmoeba(class LAMMPS *); - ~AtomVecAmoeba(); + ~AtomVecAmoeba() override; - void grow_pointers(); - void pack_restart_pre(int); - void pack_restart_post(int); - void unpack_restart_init(int); - void data_atom_post(int); + void grow_pointers() override; + void pack_restart_pre(int) override; + void pack_restart_post(int) override; + void unpack_restart_init(int) override; + void data_atom_post(int) override; private: int *num_bond, *num_angle, *num_dihedral, *num_improper; @@ -44,8 +44,6 @@ class AtomVecAmoeba : public AtomVec { int bond_per_atom, angle_per_atom, dihedral_per_atom, improper_per_atom; int *bond_negative, *angle_negative, *dihedral_negative, *improper_negative; }; - } // namespace LAMMPS_NS - #endif #endif diff --git a/src/AMOEBA/fix_amoeba_bitorsion.h b/src/AMOEBA/fix_amoeba_bitorsion.h index 2a94891d03..f9d1da3b52 100644 --- a/src/AMOEBA/fix_amoeba_bitorsion.h +++ b/src/AMOEBA/fix_amoeba_bitorsion.h @@ -26,7 +26,7 @@ namespace LAMMPS_NS { class FixAmoebaBiTorsion : public Fix { public: FixAmoebaBiTorsion(class LAMMPS *, int, char **); - ~FixAmoebaBiTorsion(); + ~FixAmoebaBiTorsion() override; int setmask() override; void init() override; void setup(int) override; @@ -121,8 +121,6 @@ class FixAmoebaBiTorsion : public Fix { double, double &, double &, double &); void bcucof(double *, double *, double *, double *, double, double, double[][4]); }; - } // namespace LAMMPS_NS - #endif #endif diff --git a/src/AMOEBA/fix_amoeba_pitorsion.h b/src/AMOEBA/fix_amoeba_pitorsion.h index 9c1f46a201..6f78cbe34c 100644 --- a/src/AMOEBA/fix_amoeba_pitorsion.h +++ b/src/AMOEBA/fix_amoeba_pitorsion.h @@ -26,43 +26,43 @@ namespace LAMMPS_NS { class FixAmoebaPiTorsion : public Fix { public: FixAmoebaPiTorsion(class LAMMPS *, int, char **); - ~FixAmoebaPiTorsion(); - int setmask(); - void init(); - void setup(int); - void setup_pre_neighbor(); - void setup_pre_reverse(int, int); - void min_setup(int); - void pre_neighbor(); - void pre_reverse(int, int); - void post_force(int); - void post_force_respa(int, int, int); - void min_post_force(int); - double compute_scalar(); + ~FixAmoebaPiTorsion() override; + int setmask() override; + void init() override; + void setup(int) override; + void setup_pre_neighbor() override; + void setup_pre_reverse(int, int) override; + void min_setup(int) override; + void pre_neighbor() override; + void pre_reverse(int, int) override; + void post_force(int) override; + void post_force_respa(int, int, int) override; + void min_post_force(int) override; + double compute_scalar() override; - void read_data_header(char *); - void read_data_section(char *, int, char *, tagint); - bigint read_data_skip_lines(char *); - void write_data_header(FILE *, int); - void write_data_section_size(int, int &, int &); - void write_data_section_pack(int, double **); - void write_data_section_keyword(int, FILE *); - void write_data_section(int, FILE *, int, double **, int); + void read_data_header(char *) override; + void read_data_section(char *, int, char *, tagint) override; + bigint read_data_skip_lines(char *) override; + void write_data_header(FILE *, int) override; + void write_data_section_size(int, int &, int &) override; + void write_data_section_pack(int, double **) override; + void write_data_section_keyword(int, FILE *) override; + void write_data_section(int, FILE *, int, double **, int) override; - void write_restart(FILE *); - void restart(char *); - int pack_restart(int, double *); - void unpack_restart(int, int); - int size_restart(int); - int maxsize_restart(); + void write_restart(FILE *) override; + void restart(char *) override; + int pack_restart(int, double *) override; + void unpack_restart(int, int) override; + int size_restart(int) override; + int maxsize_restart() override; - void grow_arrays(int); - void copy_arrays(int, int, int); - void set_arrays(int); - int pack_exchange(int, double *); - int unpack_exchange(int, double *); + void grow_arrays(int) override; + void copy_arrays(int, int, int) override; + void set_arrays(int) override; + int pack_exchange(int, double *) override; + int unpack_exchange(int, double *) override; - double memory_usage(); + double memory_usage() override; private: int nprocs, me; @@ -94,6 +94,5 @@ class FixAmoebaPiTorsion : public Fix { int **pitorsion_list; }; } // namespace LAMMPS_NS - #endif #endif diff --git a/src/AMOEBA/improper_amoeba.h b/src/AMOEBA/improper_amoeba.h index 34ed01ec83..36fdcf4da9 100644 --- a/src/AMOEBA/improper_amoeba.h +++ b/src/AMOEBA/improper_amoeba.h @@ -27,13 +27,13 @@ namespace LAMMPS_NS { class ImproperAmoeba : public Improper { public: ImproperAmoeba(class LAMMPS *); - ~ImproperAmoeba(); - void compute(int, int); - void coeff(int, char **); - void init_style(); - void write_restart(FILE *); - void read_restart(FILE *); - void write_data(FILE *); + ~ImproperAmoeba() override; + void compute(int, int) override; + void coeff(int, char **) override; + void init_style() override; + void write_restart(FILE *) override; + void read_restart(FILE *) override; + void write_data(FILE *) override; protected: int disable; @@ -42,8 +42,6 @@ class ImproperAmoeba : public Improper { virtual void allocate(); }; - } // namespace LAMMPS_NS - #endif #endif diff --git a/src/AMOEBA/pair_amoeba.h b/src/AMOEBA/pair_amoeba.h index af760e275f..2383fc6727 100644 --- a/src/AMOEBA/pair_amoeba.h +++ b/src/AMOEBA/pair_amoeba.h @@ -480,8 +480,6 @@ class PairAmoeba : public Pair { inline int sbmask15(int j) const { return j >> SBBITS15 & 7; } }; - } // namespace LAMMPS_NS - #endif #endif diff --git a/src/AMOEBA/pair_hippo.h b/src/AMOEBA/pair_hippo.h index af54fe071e..e8ad7a14ab 100644 --- a/src/AMOEBA/pair_hippo.h +++ b/src/AMOEBA/pair_hippo.h @@ -28,8 +28,6 @@ class PairHippo : public PairAmoeba { public: PairHippo(class LAMMPS *); }; - } // namespace LAMMPS_NS - #endif #endif From 82c467d79f06faa1cc982219706fd6500f7f2f66 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sun, 3 Jul 2022 06:53:13 -0400 Subject: [PATCH 521/585] remove debug code --- src/AMOEBA/pair_amoeba.cpp | 5 +---- 1 file changed, 1 insertion(+), 4 deletions(-) diff --git a/src/AMOEBA/pair_amoeba.cpp b/src/AMOEBA/pair_amoeba.cpp index 9d6695a6e0..08dbb4adc1 100644 --- a/src/AMOEBA/pair_amoeba.cpp +++ b/src/AMOEBA/pair_amoeba.cpp @@ -1,3 +1,4 @@ +// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/ Sandia National Laboratories @@ -1750,10 +1751,6 @@ void PairAmoeba::precond_neigh() int *ilist,*jlist,*numneigh,**firstneigh; int *neighptr; - // DEBUG - - if (comm->me == 0.0) printf("Reneighbor on step %ld\n",update->ntimestep); - // NOTE: no skin added to cutoff for this shorter neighbor list // also note that Tinker (and thus LAMMPS) does not apply the // distance cutoff in the CG iterations in induce.cpp, From 65797286220a9a5a7184196a37cc2a2c20f12cd0 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sun, 3 Jul 2022 06:54:22 -0400 Subject: [PATCH 522/585] apply include file conventions --- src/AMOEBA/amoeba_charge_transfer.cpp | 7 ++-- src/AMOEBA/amoeba_convolution.cpp | 10 +++--- src/AMOEBA/amoeba_convolution.h | 2 -- src/AMOEBA/amoeba_dispersion.cpp | 3 +- src/AMOEBA/amoeba_file.cpp | 16 +++++---- src/AMOEBA/amoeba_hal.cpp | 7 ++-- src/AMOEBA/amoeba_induce.cpp | 11 +++--- src/AMOEBA/amoeba_kspace.cpp | 5 ++- src/AMOEBA/amoeba_multipole.cpp | 5 +-- src/AMOEBA/amoeba_polar.cpp | 7 ++-- src/AMOEBA/amoeba_repulsion.cpp | 7 ++-- src/AMOEBA/amoeba_utils.cpp | 10 +++--- src/AMOEBA/angle_amoeba.cpp | 13 +++---- src/AMOEBA/atom_vec_amoeba.cpp | 1 + src/AMOEBA/fix_amoeba_bitorsion.cpp | 50 +++++++++++++-------------- src/AMOEBA/fix_amoeba_pitorsion.cpp | 18 +++++----- src/AMOEBA/improper_amoeba.cpp | 11 +++--- 17 files changed, 103 insertions(+), 80 deletions(-) diff --git a/src/AMOEBA/amoeba_charge_transfer.cpp b/src/AMOEBA/amoeba_charge_transfer.cpp index 0c2166d8c8..1528ea348f 100644 --- a/src/AMOEBA/amoeba_charge_transfer.cpp +++ b/src/AMOEBA/amoeba_charge_transfer.cpp @@ -1,3 +1,4 @@ +// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/ Sandia National Laboratories @@ -12,10 +13,12 @@ ------------------------------------------------------------------------- */ #include "pair_amoeba.h" -#include + #include "atom.h" -#include "neigh_list.h" #include "memory.h" +#include "neigh_list.h" + +#include using namespace LAMMPS_NS; diff --git a/src/AMOEBA/amoeba_convolution.cpp b/src/AMOEBA/amoeba_convolution.cpp index ea6b9d5293..9d08dd6e79 100644 --- a/src/AMOEBA/amoeba_convolution.cpp +++ b/src/AMOEBA/amoeba_convolution.cpp @@ -1,3 +1,4 @@ +// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/ Sandia National Laboratories @@ -12,14 +13,15 @@ ------------------------------------------------------------------------- */ #include "amoeba_convolution.h" -#include "domain.h" + #include "comm.h" -#include "update.h" -#include "neighbor.h" +#include "domain.h" #include "fft3d_wrap.h" -#include "remap_wrap.h" #include "gridcomm.h" #include "memory.h" +#include "neighbor.h" +#include "remap_wrap.h" +#include "update.h" using namespace LAMMPS_NS; diff --git a/src/AMOEBA/amoeba_convolution.h b/src/AMOEBA/amoeba_convolution.h index 9f6bb27b74..d7c4f9fbd7 100644 --- a/src/AMOEBA/amoeba_convolution.h +++ b/src/AMOEBA/amoeba_convolution.h @@ -81,7 +81,5 @@ class AmoebaConvolution : protected Pointers { void debug_scalar(int, const char *); void debug_file(int, const char *); }; - } // namespace LAMMPS_NS - #endif diff --git a/src/AMOEBA/amoeba_dispersion.cpp b/src/AMOEBA/amoeba_dispersion.cpp index febc475322..4005c3b1bd 100644 --- a/src/AMOEBA/amoeba_dispersion.cpp +++ b/src/AMOEBA/amoeba_dispersion.cpp @@ -1,3 +1,4 @@ +// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/ Sandia National Laboratories @@ -17,11 +18,11 @@ #include "atom.h" #include "comm.h" #include "domain.h" -#include "neigh_list.h" #include "fft3d_wrap.h" #include "math_const.h" #include "math_special.h" #include "memory.h" +#include "neigh_list.h" #include diff --git a/src/AMOEBA/amoeba_file.cpp b/src/AMOEBA/amoeba_file.cpp index 9359e5711c..0a379c0ed2 100644 --- a/src/AMOEBA/amoeba_file.cpp +++ b/src/AMOEBA/amoeba_file.cpp @@ -1,3 +1,4 @@ +// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel ator https://www.lammps.org/ Sandia National Laboratories @@ -12,16 +13,17 @@ ------------------------------------------------------------------------- */ #include "pair_amoeba.h" -#include + +#include "comm.h" +#include "domain.h" +#include "error.h" +#include "force.h" +#include "memory.h" +#include "utils.h" + #include #include #include -#include "domain.h" -#include "comm.h" -#include "force.h" -#include "memory.h" -#include "error.h" -#include "utils.h" using namespace LAMMPS_NS; diff --git a/src/AMOEBA/amoeba_hal.cpp b/src/AMOEBA/amoeba_hal.cpp index 999911671e..21bb7ad099 100644 --- a/src/AMOEBA/amoeba_hal.cpp +++ b/src/AMOEBA/amoeba_hal.cpp @@ -1,3 +1,4 @@ +// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/ Sandia National Laboratories @@ -12,10 +13,12 @@ ------------------------------------------------------------------------- */ #include "pair_amoeba.h" -#include + #include "atom.h" -#include "neigh_list.h" #include "error.h" +#include "neigh_list.h" + +#include using namespace LAMMPS_NS; diff --git a/src/AMOEBA/amoeba_induce.cpp b/src/AMOEBA/amoeba_induce.cpp index 9398cbf593..12baf440e1 100644 --- a/src/AMOEBA/amoeba_induce.cpp +++ b/src/AMOEBA/amoeba_induce.cpp @@ -1,3 +1,4 @@ +// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/ Sandia National Laboratories @@ -15,15 +16,15 @@ #include "amoeba_convolution.h" #include "atom.h" -#include "domain.h" #include "comm.h" -#include "fix_store.h" -#include "neigh_list.h" +#include "domain.h" +#include "error.h" #include "fft3d_wrap.h" -#include "my_page.h" +#include "fix_store.h" #include "math_const.h" #include "memory.h" -#include "error.h" +#include "my_page.h" +#include "neigh_list.h" #include #include diff --git a/src/AMOEBA/amoeba_kspace.cpp b/src/AMOEBA/amoeba_kspace.cpp index 6f76c7ec51..22b83c1b59 100644 --- a/src/AMOEBA/amoeba_kspace.cpp +++ b/src/AMOEBA/amoeba_kspace.cpp @@ -1,3 +1,4 @@ +// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/ Sandia National Laboratories @@ -12,12 +13,14 @@ ------------------------------------------------------------------------- */ #include "pair_amoeba.h" -#include + #include "atom.h" #include "domain.h" #include "math_const.h" #include "memory.h" +#include + using namespace LAMMPS_NS; using namespace MathConst; diff --git a/src/AMOEBA/amoeba_multipole.cpp b/src/AMOEBA/amoeba_multipole.cpp index 4b12e14957..5d11bde1ab 100644 --- a/src/AMOEBA/amoeba_multipole.cpp +++ b/src/AMOEBA/amoeba_multipole.cpp @@ -1,3 +1,4 @@ +// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/ Sandia National Laboratories @@ -15,12 +16,12 @@ #include "amoeba_convolution.h" #include "atom.h" -#include "domain.h" #include "comm.h" -#include "neigh_list.h" +#include "domain.h" #include "fft3d_wrap.h" #include "math_const.h" #include "memory.h" +#include "neigh_list.h" #include #include diff --git a/src/AMOEBA/amoeba_polar.cpp b/src/AMOEBA/amoeba_polar.cpp index 2dbd941649..f0670ea8c6 100644 --- a/src/AMOEBA/amoeba_polar.cpp +++ b/src/AMOEBA/amoeba_polar.cpp @@ -1,3 +1,4 @@ +// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/ Sandia National Laboratories @@ -12,15 +13,15 @@ ------------------------------------------------------------------------- */ #include "pair_amoeba.h" -#include "amoeba_convolution.h" +#include "amoeba_convolution.h" #include "atom.h" -#include "domain.h" #include "comm.h" -#include "neigh_list.h" +#include "domain.h" #include "fft3d_wrap.h" #include "math_const.h" #include "memory.h" +#include "neigh_list.h" #include #include diff --git a/src/AMOEBA/amoeba_repulsion.cpp b/src/AMOEBA/amoeba_repulsion.cpp index 1cad7caa44..0784a32d0b 100644 --- a/src/AMOEBA/amoeba_repulsion.cpp +++ b/src/AMOEBA/amoeba_repulsion.cpp @@ -1,3 +1,4 @@ +// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/ Sandia National Laboratories @@ -12,11 +13,13 @@ ------------------------------------------------------------------------- */ #include "pair_amoeba.h" -#include + #include "atom.h" #include "comm.h" -#include "neigh_list.h" #include "memory.h" +#include "neigh_list.h" + +#include using namespace LAMMPS_NS; diff --git a/src/AMOEBA/amoeba_utils.cpp b/src/AMOEBA/amoeba_utils.cpp index 94a9d7fe51..c44c206273 100644 --- a/src/AMOEBA/amoeba_utils.cpp +++ b/src/AMOEBA/amoeba_utils.cpp @@ -12,13 +12,15 @@ ------------------------------------------------------------------------- */ #include "pair_amoeba.h" -#include + #include "atom.h" -#include "domain.h" #include "comm.h" -#include "neigh_list.h" -#include "fix_store.h" +#include "domain.h" #include "error.h" +#include "fix_store.h" +#include "neigh_list.h" + +#include using namespace LAMMPS_NS; diff --git a/src/AMOEBA/angle_amoeba.cpp b/src/AMOEBA/angle_amoeba.cpp index 1376dbcd5c..4b9342f058 100644 --- a/src/AMOEBA/angle_amoeba.cpp +++ b/src/AMOEBA/angle_amoeba.cpp @@ -14,17 +14,18 @@ #include "angle_amoeba.h" -#include -#include #include "atom.h" -#include "neighbor.h" -#include "domain.h" #include "comm.h" +#include "domain.h" +#include "error.h" #include "force.h" -#include "pair.h" #include "math_const.h" #include "memory.h" -#include "error.h" +#include "neighbor.h" +#include "pair.h" + +#include +#include using namespace LAMMPS_NS; using namespace MathConst; diff --git a/src/AMOEBA/atom_vec_amoeba.cpp b/src/AMOEBA/atom_vec_amoeba.cpp index eb6935a9dd..71f614dc40 100644 --- a/src/AMOEBA/atom_vec_amoeba.cpp +++ b/src/AMOEBA/atom_vec_amoeba.cpp @@ -12,6 +12,7 @@ ------------------------------------------------------------------------- */ #include "atom_vec_amoeba.h" + #include "atom.h" using namespace LAMMPS_NS; diff --git a/src/AMOEBA/fix_amoeba_bitorsion.cpp b/src/AMOEBA/fix_amoeba_bitorsion.cpp index 85a87b0452..0996a37cfd 100644 --- a/src/AMOEBA/fix_amoeba_bitorsion.cpp +++ b/src/AMOEBA/fix_amoeba_bitorsion.cpp @@ -14,19 +14,19 @@ #include "fix_amoeba_bitorsion.h" -#include - -#include #include "atom.h" -#include "update.h" -#include "respa.h" -#include "domain.h" -#include "force.h" -#include "pair.h" #include "comm.h" +#include "domain.h" +#include "error.h" +#include "force.h" #include "math_const.h" #include "memory.h" -#include "error.h" +#include "pair.h" +#include "respa.h" +#include "update.h" + +#include +#include using namespace LAMMPS_NS; using namespace FixConst; @@ -40,22 +40,22 @@ using namespace MathConst; // spline weighting factors static constexpr double WT[16][16] = { -{ 1.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0}, -{ 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 1.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0}, -{-3.0, 0.0, 0.0, 3.0, 0.0, 0.0, 0.0, 0.0,-2.0, 0.0, 0.0,-1.0, 0.0, 0.0, 0.0, 0.0}, -{ 2.0, 0.0, 0.0,-2.0, 0.0, 0.0, 0.0, 0.0, 1.0, 0.0, 0.0, 1.0, 0.0, 0.0, 0.0, 0.0}, -{ 0.0, 0.0, 0.0, 0.0, 1.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0}, -{ 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 1.0, 0.0, 0.0, 0.0}, -{ 0.0, 0.0, 0.0, 0.0,-3.0, 0.0, 0.0, 3.0, 0.0, 0.0, 0.0, 0.0,-2.0, 0.0, 0.0,-1.0}, -{ 0.0, 0.0, 0.0, 0.0, 2.0, 0.0, 0.0,-2.0, 0.0, 0.0, 0.0, 0.0, 1.0, 0.0, 0.0, 1.0}, -{-3.0, 3.0, 0.0, 0.0,-2.0,-1.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0}, -{ 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0,-3.0, 3.0, 0.0, 0.0,-2.0,-1.0, 0.0, 0.0}, -{ 9.0,-9.0, 9.0,-9.0, 6.0, 3.0,-3.0,-6.0, 6.0,-6.0,-3.0, 3.0, 4.0, 2.0, 1.0, 2.0}, -{-6.0, 6.0,-6.0, 6.0,-4.0,-2.0, 2.0, 4.0,-3.0, 3.0, 3.0,-3.0,-2.0,-1.0,-1.0,-2.0}, -{ 2.0,-2.0, 0.0, 0.0, 1.0, 1.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0}, -{ 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 2.0,-2.0, 0.0, 0.0, 1.0, 1.0, 0.0, 0.0}, -{-6.0, 6.0,-6.0, 6.0,-3.0,-3.0, 3.0, 3.0,-4.0, 4.0, 2.0,-2.0,-2.0,-2.0,-1.0,-1.0}, -{ 4.0,-4.0, 4.0,-4.0, 2.0, 2.0,-2.0,-2.0, 2.0,-2.0,-2.0, 2.0, 1.0, 1.0, 1.0, 1.0} + { 1.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0}, + { 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 1.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0}, + {-3.0, 0.0, 0.0, 3.0, 0.0, 0.0, 0.0, 0.0,-2.0, 0.0, 0.0,-1.0, 0.0, 0.0, 0.0, 0.0}, + { 2.0, 0.0, 0.0,-2.0, 0.0, 0.0, 0.0, 0.0, 1.0, 0.0, 0.0, 1.0, 0.0, 0.0, 0.0, 0.0}, + { 0.0, 0.0, 0.0, 0.0, 1.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0}, + { 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 1.0, 0.0, 0.0, 0.0}, + { 0.0, 0.0, 0.0, 0.0,-3.0, 0.0, 0.0, 3.0, 0.0, 0.0, 0.0, 0.0,-2.0, 0.0, 0.0,-1.0}, + { 0.0, 0.0, 0.0, 0.0, 2.0, 0.0, 0.0,-2.0, 0.0, 0.0, 0.0, 0.0, 1.0, 0.0, 0.0, 1.0}, + {-3.0, 3.0, 0.0, 0.0,-2.0,-1.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0}, + { 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0,-3.0, 3.0, 0.0, 0.0,-2.0,-1.0, 0.0, 0.0}, + { 9.0,-9.0, 9.0,-9.0, 6.0, 3.0,-3.0,-6.0, 6.0,-6.0,-3.0, 3.0, 4.0, 2.0, 1.0, 2.0}, + {-6.0, 6.0,-6.0, 6.0,-4.0,-2.0, 2.0, 4.0,-3.0, 3.0, 3.0,-3.0,-2.0,-1.0,-1.0,-2.0}, + { 2.0,-2.0, 0.0, 0.0, 1.0, 1.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0}, + { 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 0.0, 2.0,-2.0, 0.0, 0.0, 1.0, 1.0, 0.0, 0.0}, + {-6.0, 6.0,-6.0, 6.0,-3.0,-3.0, 3.0, 3.0,-4.0, 4.0, 2.0,-2.0,-2.0,-2.0,-1.0,-1.0}, + { 4.0,-4.0, 4.0,-4.0, 2.0, 2.0,-2.0,-2.0, 2.0,-2.0,-2.0, 2.0, 1.0, 1.0, 1.0, 1.0} }; /* ---------------------------------------------------------------------- */ diff --git a/src/AMOEBA/fix_amoeba_pitorsion.cpp b/src/AMOEBA/fix_amoeba_pitorsion.cpp index e5c19b43c2..d8d712cfcb 100644 --- a/src/AMOEBA/fix_amoeba_pitorsion.cpp +++ b/src/AMOEBA/fix_amoeba_pitorsion.cpp @@ -14,19 +14,19 @@ #include "fix_amoeba_pitorsion.h" -#include - -#include #include "atom.h" -#include "update.h" -#include "respa.h" -#include "domain.h" -#include "force.h" -#include "pair.h" #include "comm.h" +#include "domain.h" +#include "error.h" +#include "force.h" #include "math_const.h" #include "memory.h" -#include "error.h" +#include "pair.h" +#include "respa.h" +#include "update.h" + +#include +#include using namespace LAMMPS_NS; using namespace FixConst; diff --git a/src/AMOEBA/improper_amoeba.cpp b/src/AMOEBA/improper_amoeba.cpp index df3a6584cf..93e07f662f 100644 --- a/src/AMOEBA/improper_amoeba.cpp +++ b/src/AMOEBA/improper_amoeba.cpp @@ -14,16 +14,17 @@ #include "improper_amoeba.h" -#include #include "atom.h" #include "comm.h" -#include "update.h" -#include "neighbor.h" +#include "error.h" #include "force.h" -#include "pair.h" #include "math_const.h" #include "memory.h" -#include "error.h" +#include "neighbor.h" +#include "pair.h" +#include "update.h" + +#include using namespace LAMMPS_NS; using namespace MathConst; From 75667718acefa282d5f1399f054a52d34744b824 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sun, 3 Jul 2022 06:54:33 -0400 Subject: [PATCH 523/585] simplify printing errors --- src/AMOEBA/amoeba_utils.cpp | 15 +++++---------- 1 file changed, 5 insertions(+), 10 deletions(-) diff --git a/src/AMOEBA/amoeba_utils.cpp b/src/AMOEBA/amoeba_utils.cpp index c44c206273..c96f7f305c 100644 --- a/src/AMOEBA/amoeba_utils.cpp +++ b/src/AMOEBA/amoeba_utils.cpp @@ -1,3 +1,4 @@ +// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/ Sandia National Laboratories @@ -273,11 +274,8 @@ void PairAmoeba::kmpole() int nmissing_all; MPI_Allreduce(&nmissing,&nmissing_all,1,MPI_INT,MPI_SUM,world); - if (nmissing_all) { - char str[128]; - sprintf(str,"Pair amoeba multipole settings missing %d\n",nmissing_all); - error->all(FLERR,str); - } + if (nmissing_all) + error->all(FLERR, "Pair amoeba: {} multipole settings missing\n", nmissing_all); } /* ---------------------------------------------------------------------- @@ -761,11 +759,8 @@ void PairAmoeba::find_multipole_neighbors() int nmissing_all; MPI_Allreduce(&nmissing,&nmissing_all,1,MPI_INT,MPI_SUM,world); - if (nmissing_all) { - char str[128]; - sprintf(str,"Pair amoeba multipole neighbors missing %d\n",nmissing_all); - error->all(FLERR,str); - } + if (nmissing_all) + error->all(FLERR, "Pair amoeba: {} multipole neighbors missing\n", nmissing_all); } /* ---------------------------------------------------------------------- From e13027787b5857215b20aa38f16066367cf75b84 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 4 Jul 2022 13:36:14 -0400 Subject: [PATCH 524/585] simplify parsing of PRM file section header --- src/AMOEBA/amoeba_file.cpp | 147 ++++++++++++++----------------------- src/AMOEBA/pair_amoeba.h | 1 - 2 files changed, 54 insertions(+), 94 deletions(-) diff --git a/src/AMOEBA/amoeba_file.cpp b/src/AMOEBA/amoeba_file.cpp index 0a379c0ed2..b4b6726838 100644 --- a/src/AMOEBA/amoeba_file.cpp +++ b/src/AMOEBA/amoeba_file.cpp @@ -29,7 +29,7 @@ using namespace LAMMPS_NS; enum{FFIELD,LITERATURE,ATOMTYPE,VDWL,VDWLPAIR,BSTRETCH,SBEND,ABEND, PAULI,DISPERSION,UB,OUTPLANE,TORSION,PITORSION,ATOMMULT, - QPENETRATION,DIPPOLAR,QTRANSFER,UNKNOWN}; + QPENETRATION,DIPPOLAR,QTRANSFER,UNKNOWN,END_OF_FILE}; enum{ALLINGER,BUFFERED_14_7}; enum{ARITHMETIC,GEOMETRIC,CUBIC_MEAN,R_MIN,SIGMA,DIAMETER,HARMONIC,HHG,W_H}; enum{MUTUAL,OPT,TCG,DIRECT}; @@ -87,11 +87,8 @@ void PairAmoeba::read_prmfile(char *filename) if (me == 0) { fptr = utils::open_potential(filename,lmp,nullptr); - if (fptr == nullptr) { - char str[128]; - snprintf(str,128,"Cannot open AMOEBA PRM file %s",filename); - error->one(FLERR,str); - } + if (fptr == nullptr) error->one(FLERR, "Cannot open {} PRM file {}: {}", + utils::uppercase(mystyle), filename, utils::getsyserror()); } // read sections, one at a time @@ -103,47 +100,65 @@ void PairAmoeba::read_prmfile(char *filename) int forcefield_flag = 0; int atomtype_flag = 0; int section; + int nline = 0; while (true) { - if (me == 0) n = read_section_name(fptr,line); - MPI_Bcast(&n,1,MPI_INT,0,world); - if (n < 0) break; - MPI_Bcast(line,n+1,MPI_CHAR,0,world); + if (me == 0) { + clearerr(fptr); + section = END_OF_FILE; + while (fgets(line, MAXLINE, fptr)) { + ++nline; + if (utils::strmatch(line, "^\\s*##\\s+\\S+.*##\\s*$")) { + auto trimmed = utils::trim(line); + if (utils::strmatch(trimmed, "^##\\s*Force Field")) section = FFIELD; + else if (utils::strmatch(trimmed, "^##\\s*Literature")) section = LITERATURE; + else if (utils::strmatch(trimmed, "^##\\s*Atom Type")) section = ATOMTYPE; + else if (utils::strmatch(trimmed, "^##\\s*Van der Waals Param")) section = VDWL; + else if (utils::strmatch(trimmed, "^##\\s*Van der Waals Pair")) section = VDWLPAIR; + else if (utils::strmatch(trimmed, "^##\\s*Bond Stretching")) section = BSTRETCH; + else if (utils::strmatch(trimmed, "^##\\s*Stretch-Bend")) section = SBEND; + else if (utils::strmatch(trimmed, "^##\\s*Angle Bending")) section = ABEND; + else if (utils::strmatch(trimmed, "^##\\s*Pauli Repulsion")) section = PAULI; + else if (utils::strmatch(trimmed, "^##\\s*Dispersion Param")) section = DISPERSION; + else if (utils::strmatch(trimmed, "^##\\s*Urey-Bradley")) section = UB; + else if (utils::strmatch(trimmed, "^##\\s*Out-of-Plane")) section = OUTPLANE; + else if (utils::strmatch(trimmed, "^##\\s*Torsional")) section = TORSION; + else if (utils::strmatch(trimmed, "^##\\s*Pi-Torsion")) section = PITORSION; + else if (utils::strmatch(trimmed, "^##\\s*Atomic Multipole")) section = ATOMMULT; + else if (utils::strmatch(trimmed, "^##\\s*Charge Penetration")) section = QPENETRATION; + else if (utils::strmatch(trimmed, "^##\\s*Dipole Polarizability")) section = DIPPOLAR; + else if (utils::strmatch(trimmed, "^##\\s*Charge Transfer")) section = QTRANSFER; + else { + section = UNKNOWN; + utils::logmesg(lmp, "Skipping section: {}\n", trimmed.substr(2,trimmed.size()-4)); + } - if (strstr(line,"Force Field") == line) section = FFIELD; - else if (strstr(line,"Literature") == line) section = LITERATURE; - else if (strstr(line,"Atom Type") == line) section = ATOMTYPE; - else if (strstr(line,"Van der Waals Param") == line) section = VDWL; - else if (strstr(line,"Van der Waals Pair") == line) section = VDWLPAIR; - else if (strstr(line,"Bond Stretching") == line) section = BSTRETCH; - else if (strstr(line,"Stretch-Bend") == line) section = SBEND; - else if (strstr(line,"Angle Bending") == line) section = ABEND; - else if (strstr(line,"Pauli Repulsion") == line) section = PAULI; - else if (strstr(line,"Dispersion Param") == line) section = DISPERSION; - else if (strstr(line,"Urey-Bradley") == line) section = UB; - else if (strstr(line,"Out-of-Plane") == line) section = OUTPLANE; - else if (strstr(line,"Torsional") == line) section = TORSION; - else if (strstr(line,"Pi-Torsion") == line) section = PITORSION; - else if (strstr(line,"Atomic Multipole") == line) section = ATOMMULT; - else if (strstr(line,"Charge Penetration") == line) section = QPENETRATION; - else if (strstr(line,"Dipole Polarizability") == line) section = DIPPOLAR; - else if (strstr(line,"Charge Transfer") == line) section = QTRANSFER; - else { - if (me == 0) printf("Skipping section: %s\n",line); - section = UNKNOWN; + // skip two lines following section head keyword + fgets(line, MAXLINE, fptr); + fgets(line, MAXLINE, fptr); + nline += 2; + break; + } + } + if (ferror(fptr)) + error->one(FLERR, "Problem reading {} PRM file {}:{} {}", + utils::uppercase(mystyle), nline, filename, utils::getsyserror()); + if (feof(fptr)) section = END_OF_FILE; } + MPI_Bcast(§ion, 1, MPI_INT, 0, world); + if (section == END_OF_FILE) break; - if (forcefield_flag == 0 && section != FFIELD) - error->all(FLERR,"Force Field is not first section of " - "pair amoeba potential file"); - if (section != FFIELD && section != LITERATURE && section != ATOMTYPE && - section != UNKNOWN && atomtype_flag == 0) - error->all(FLERR,"Atom Type section of pair amoeba potential file " - "must come before all but Force Field section"); + // sanity checks + if ((forcefield_flag == 0) && (section != FFIELD)) + error->all(FLERR,"Force Field is not first section of pair {} potential file", mystyle); + + if ((section != FFIELD) && (section != LITERATURE) && (section != ATOMTYPE) && + (section != UNKNOWN) && (atomtype_flag == 0)) + error->all(FLERR,"Atom Type section of pair {} potential file must " + "come before all but the Force Field section", mystyle); if (section == FFIELD) forcefield_flag = 1; if (section == ATOMTYPE) atomtype_flag = 1; - if (section == ATOMMULT) { for (int i = 1; i <= n_amtype; i++) nmultiframe[i] = 0; } @@ -541,60 +556,6 @@ void PairAmoeba::read_keyfile(char *filename) /* ---------------------------------------------------------------------- */ -int PairAmoeba::read_section_name(FILE *fp, char *line) -{ - char dummy[MAXLINE]; - - // loop on read line - // return -1 if EOF - // skip line if blank - // tokenize - // if ncount <= 2 skip line - // if 1st word and last word != ## then error - // pack line with 2nd thru next-to-last words - // return length of line - - char *ptr,*copy; - char **words; - int nwords; - - while (true) { - ptr = fgets(line,MAXLINE,fp); - if (!ptr) return -1; - if (strspn(line," \t\n\r") == strlen(line)) continue; - nwords = tokenize(line,words,copy); - if (nwords <= 2) { - delete[] copy; - delete[] words; - continue; - } - break; - } - - if ((strstr(words[0],"##") != words[0]) || - (strstr(words[nwords-1],"##") != words[nwords-1])) - error->one(FLERR,"Section header of pair amoeba potential file is invalid"); - - line[0] = '\0'; - for (int i = 1; i < nwords-1; i++) { - if (i > 1) strcat(line," "); - strcat(line,words[i]); - } - int n = strlen(line); - - delete[] copy; - delete[] words; - - // skip next 2 lines of section header - - fgets(dummy,MAXLINE,fp); - fgets(dummy,MAXLINE,fp); - - return n; -} - -/* ---------------------------------------------------------------------- */ - int PairAmoeba::read_section_line(FILE *fp, char *line, int &nextflag, char *next) { diff --git a/src/AMOEBA/pair_amoeba.h b/src/AMOEBA/pair_amoeba.h index 2383fc6727..2fa211fbfc 100644 --- a/src/AMOEBA/pair_amoeba.h +++ b/src/AMOEBA/pair_amoeba.h @@ -448,7 +448,6 @@ class PairAmoeba : public Pair { void read_prmfile(char *); void read_keyfile(char *); - int read_section_name(FILE *fp, char *); int read_section_line(FILE *fp, char *, int &, char *); int tokenize(char *, char **&, char *&); int count_words(const char *); From de08609634fe4f49aa772f99deb7412386a05d31 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 4 Jul 2022 18:26:59 -0400 Subject: [PATCH 525/585] add join_words() utility function --- doc/src/Developer_utils.rst | 3 +++ src/utils.cpp | 13 +++++++++++++ src/utils.h | 11 +++++++++++ 3 files changed, 27 insertions(+) diff --git a/doc/src/Developer_utils.rst b/doc/src/Developer_utils.rst index 0932276a58..43f12ef377 100644 --- a/doc/src/Developer_utils.rst +++ b/doc/src/Developer_utils.rst @@ -154,6 +154,9 @@ and parsing files or arguments. .. doxygenfunction:: trim_and_count_words :project: progguide +.. doxygenfunction:: join_words + :project: progguide + .. doxygenfunction:: split_words :project: progguide diff --git a/src/utils.cpp b/src/utils.cpp index 87de538dfb..eb9e48985a 100644 --- a/src/utils.cpp +++ b/src/utils.cpp @@ -984,6 +984,19 @@ size_t utils::trim_and_count_words(const std::string &text, const std::string &s return utils::count_words(trim_comment(text), separators); } +/* ---------------------------------------------------------------------- + combine words in vector to single string with separator added between words +------------------------------------------------------------------------- */ +std::string utils::join_words(const std::vector &words, const std::string &sep) +{ + std::string result; + + if (words.size() > 0) result = words[0]; + for (std::size_t i = 1; i < words.size(); ++i) result += sep + words[i]; + + return result; +} + /* ---------------------------------------------------------------------- Convert string into words on whitespace while handling single and double quotes. diff --git a/src/utils.h b/src/utils.h index 6726240d0d..a88244b694 100644 --- a/src/utils.h +++ b/src/utils.h @@ -486,6 +486,17 @@ namespace utils { size_t trim_and_count_words(const std::string &text, const std::string &separators = " \t\r\n\f"); + /*! Take list of words and join them with a given separator text. + * + * This is the inverse operation of what the split_words() function + * Tokenizer classes do. + * + * \param words STL vector with strings + * \param sep separator string (may be empty) + * \return string with the concatenated words and separators */ + + std::string join_words(const std::vector &words, const std::string &sep); + /*! Take text and split into non-whitespace words. * * This can handle strings with single and double quotes, escaped quotes, From 5331fa7a58fbd82661435739223f1a7dd5a7797d Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 4 Jul 2022 19:09:56 -0400 Subject: [PATCH 526/585] fix documentation issues (spelling, references, non-ASCII chars) --- doc/src/Howto_amoeba.rst | 14 ++++----- doc/src/angle_amoeba.rst | 8 ++--- doc/src/fix_amoeba_bitorsion.rst | 4 +-- doc/src/fix_amoeba_pitorsion.rst | 2 +- doc/src/improper_amoeba.rst | 4 +-- doc/src/pair_amoeba.rst | 32 +++++++++---------- doc/utils/sphinx-config/false_positives.txt | 35 +++++++++++++++++++++ 7 files changed, 67 insertions(+), 32 deletions(-) diff --git a/doc/src/Howto_amoeba.rst b/doc/src/Howto_amoeba.rst index b804fb8d1a..44458fcfdc 100644 --- a/doc/src/Howto_amoeba.rst +++ b/doc/src/Howto_amoeba.rst @@ -6,10 +6,10 @@ Ponder's group at the U Washington at St Louis. Their implementation in LAMMPS was done using F90 code provided by the Ponder group from their `Tinker MD code `_. -The current implementaion (May 2022) of AMOEBA in LAMMPS matches the +The current implementation (July 2022) of AMOEBA in LAMMPS matches the version discussed in :ref:`(Ponder) `, :ref:`(Ren) `, and :ref:`(Shi) `. Likewise the current -implementaion of HIPPO in LAMMPS matches the version discussed in +implementation of HIPPO in LAMMPS matches the version discussed in :ref:`(Rackers) `. These force fields can be used when polarization effects are desired @@ -140,7 +140,7 @@ amoeba/bitorsion ` command be defined. In the example above, the IDs for these two fixes are *pit* and *bit*. Of course, if the system being modeled does not have one or more of -the following -- bond, angle, dihedral, improper, pitorision, +the following -- bond, angle, dihedral, improper, pitorsion, bitorsion interactions -- then the corresponding style and fix commands above do not need to be used. See the example scripts in examples/amoeba for water systems as examples; they are simpler than @@ -157,7 +157,7 @@ namely a PRM and KEY file. The keyfile can be specified as NULL and default values for a various settings will be used. Note that these 2 files are meant to allow use of native Tinker files as-is. However LAMMPS does not support all the options which can be included -in a Tinker PRM or KEY file. See specifis below. +in a Tinker PRM or KEY file. See specifics below. A :doc:`special_bonds ` command with the *one/five* option is required, since the AMOEBA/HIPPO force fields define @@ -308,11 +308,11 @@ compatible with the LAMMPS data file format. .. _howto-Ponder: -**(Ponder)** Ponder, Wu, Ren, Pande, Chodera†, Schnieders, Haque, Mobley, Lambrecht, DiStasio Jr, M. Head-Gordon, Clark, Johnson, T. Head-Gordon, J Phys Chem B, 114, 2549–2564 (2010). +**(Ponder)** Ponder, Wu, Ren, Pande, Chodera, Schnieders, Haque, Mobley, Lambrecht, DiStasio Jr, M. Head-Gordon, Clark, Johnson, T. Head-Gordon, J Phys Chem B, 114, 2549-2564 (2010). .. _howto-Rackers: -**(Rackers)** Rackers, Silva, Wang, Ponder, J Chem Theory Comput, 17, 7056–7084 (2021). +**(Rackers)** Rackers, Silva, Wang, Ponder, J Chem Theory Comput, 17, 7056-7084 (2021). .. _howto-Ren: @@ -320,5 +320,5 @@ compatible with the LAMMPS data file format. .. _howto-Shi: -**(Shi)** Shi, Xiz, Znahg, Best, Wu, Ponder, Ren, J Chem Theory Comp, 9, 4046, 2013. +**(Shi)** Shi, Xia, Zhang, Best, Wu, Ponder, Ren, J Chem Theory Comp, 9, 4046, 2013. diff --git a/doc/src/angle_amoeba.rst b/doc/src/angle_amoeba.rst index 5ff286c8db..265c4812f9 100644 --- a/doc/src/angle_amoeba.rst +++ b/doc/src/angle_amoeba.rst @@ -41,8 +41,8 @@ length. These formulas match how the Tinker MD code performs its angle calculations for the AMOEBA and HIPPO force fields. See the -:doc:`Howto amoeba ` doc page for more information about -the implemention of AMOEBA and HIPPO in LAMMPS. +:doc:`Howto amoeba ` page for more information about +the implementation of AMOEBA and HIPPO in LAMMPS. Note that the :math:`E_a` and :math:`E_{ba}` formulas are identical to those used for the :doc:`angle_style class2/p6 ` @@ -75,7 +75,7 @@ restart files read by the :doc:`read_data ` or These are the 8 coefficients for the :math:`E_a` formula: * pflag = 0 or 1 -* ublag = 0 or 1 +* ubflag = 0 or 1 * :math:`\theta_0` (degrees) * :math:`K_2` (energy) * :math:`K_3` (energy) @@ -87,7 +87,7 @@ A pflag value of 0 vs 1 selects between the "in-plane" and "out-of-plane" options described above. Ubflag is 1 if there is a Urey-Bradley term associated with this angle type, else it is 0. :math:`\theta_0` is specified in degrees, but LAMMPS converts it to -radians internally; hence the various :math:`K` vaues are effectively +radians internally; hence the various :math:`K` values are effectively energy per radian\^2 or radian\^3 or radian\^4 or radian\^5 or radian\^6. diff --git a/doc/src/fix_amoeba_bitorsion.rst b/doc/src/fix_amoeba_bitorsion.rst index 2a4a4a62d9..74b3aced49 100644 --- a/doc/src/fix_amoeba_bitorsion.rst +++ b/doc/src/fix_amoeba_bitorsion.rst @@ -30,8 +30,8 @@ This command enables 5-body torsion/torsion interactions to be added to simulations which use the AMOEBA and HIPPO force fields. It matches how the Tinker MD code computes its torsion/torsion interactions for the AMOEBA and HIPPO force fields. See the -:doc:`Howto amoeba ` doc page for more information about -the implemention of AMOEBA and HIPPO in LAMMPS. +:doc:`Howto amoeba ` doc page for more information about +the implementation of AMOEBA and HIPPO in LAMMPS. Bitorsion interactions add additional potential energy contributions to pairs of overlapping phi-psi dihedrals of amino-acids, which are diff --git a/doc/src/fix_amoeba_pitorsion.rst b/doc/src/fix_amoeba_pitorsion.rst index 638f72c2d3..9653807143 100644 --- a/doc/src/fix_amoeba_pitorsion.rst +++ b/doc/src/fix_amoeba_pitorsion.rst @@ -30,7 +30,7 @@ This command enables 6-body pitorsion interactions to be added to simulations which use the AMOEBA and HIPPO force fields. It matches how the Tinker MD code computes its pitorsion interactions for the AMOEBA and HIPPO force fields. See the :doc:`Howto amoeba -` doc page for more information about the implemention +` doc page for more information about the implementation of AMOEBA and HIPPO in LAMMPS. Pitorsion interactions add additional potential energy contributions diff --git a/doc/src/improper_amoeba.rst b/doc/src/improper_amoeba.rst index b5507235a2..9b8260b853 100644 --- a/doc/src/improper_amoeba.rst +++ b/doc/src/improper_amoeba.rst @@ -35,8 +35,8 @@ This formula seems like a simplified version of the formula for the :math:`\chi_0` = 0.0. However the computation of the angle :math:`\chi` is done differently to match how the Tinker MD code computes its out-of-plane improper for the AMOEBA and HIPPO force -fields. See the :doc:`Howto amoeba ` doc page for more -information about the implemention of AMOEBA and HIPPO in LAMMPS. +fields. See the :doc:`Howto amoeba ` doc page for more +information about the implementation of AMOEBA and HIPPO in LAMMPS. If the 4 atoms in an improper quadruplet (listed in the data file read by the :doc:`read_data ` command are ordered I,J,K,L then diff --git a/doc/src/pair_amoeba.rst b/doc/src/pair_amoeba.rst index 726917624f..a58eb2fabc 100644 --- a/doc/src/pair_amoeba.rst +++ b/doc/src/pair_amoeba.rst @@ -32,7 +32,7 @@ Examples Additional info """"""""""""""" -* :doc:`Howto amoeba ` +* :doc:`Howto amoeba ` * examples/amoeba * tools/amoeba * potentials/\*.amoeba @@ -41,10 +41,10 @@ Additional info Description """"""""""" -The *amoeba* style computes the AMOEBA polarizeable field formulated +The *amoeba* style computes the AMOEBA polarizable field formulated by Jay Ponder's group at the U Washington at St Louis :ref:`(Ren) `, :ref:`(Shi) `. The *hippo* style computes -the HIPPO polarizeable force field, an extension to AMOEBA, formulated +the HIPPO polarizable force field, an extension to AMOEBA, formulated by Josh Rackers and collaborators in the Ponder group :ref:`(Rackers) `. @@ -56,7 +56,7 @@ the LAMMPS potentials directory with a "amoeba" or "hippo" suffix can be used. The Tinker distribution and website have additional force field files as well. -As discussed on the :doc:`Howto amoeba ` doc page, the +As discussed on the :doc:`Howto amoeba ` doc page, the intermolecular (non-bonded) portion of the AMOEBA force field contains these terms: @@ -76,7 +76,7 @@ Conceptually, these terms compute the following interactions: * :math:`U_{repulsion}` = Pauli repulsion due to rearrangement of electron density * :math:`U_{dispersion}` = dispersion between correlated, instantaneous induced dipole moments * :math:`U_{multipole}` = electrostatics between permanent point charges, dipoles, and quadrupoles -* :math:`U_{polar}` = electronic polarization bewteen induced point dipoles +* :math:`U_{polar}` = electronic polarization between induced point dipoles * :math:`U_{qxfer}` = charge transfer effects Note that the AMOEBA versus HIPPO force fields typically compute the @@ -121,10 +121,10 @@ The implementation of the AMOEBA and HIPPO force fields in LAMMPS was done using F90 code provided by the Ponder group from their `Tinker MD code `_. -The current implementaion (May 2022) of AMOEBA in LAMMPS matches the +The current implementation (July 2022) of AMOEBA in LAMMPS matches the version discussed in :ref:`(Ponder) `, :ref:`(Ren) -`, and :ref:`(Shi) `. Likewise th current -implementaion of HIPPO in LAMMPS matches the version discussed in +`, and :ref:`(Shi) `. Likewise the current +implementation of HIPPO in LAMMPS matches the version discussed in :ref:`(Rackers) `. ---------- @@ -146,12 +146,12 @@ lines. A Tinker KEY file is composed of lines, each of which has a keyword followed by zero or more parameters. The list of PRM sections and KEY keywords which LAMMPS recognizes are -listed on the :doc:`Howto amoeba ` doc page. If not +listed on the :doc:`Howto amoeba ` doc page. If not recognized, the section or keyword is skipped. Note that if the KEY file is specified as NULL, then no file is required; default values for various AMOEBA/HIPPO settings are used. -The :doc:`Howto amoeba ` doc page also gives the default +The :doc:`Howto amoeba ` doc page also gives the default settings. ---------- @@ -181,9 +181,9 @@ enabled if LAMMPS was built with that package. See the :doc:`Build package ` doc page for more info. The AMOEBA and HIPPO potential (PRM) and KEY files provided with -LAMMPS in the potentials and examples/amoeva directories are Tinker +LAMMPS in the potentials and examples/amoeba directories are Tinker files parameterized for Tinker units. Their numeric parameters are -converted by LAMMPS to its real units :doc:`units `. Thus uou +converted by LAMMPS to its real units :doc:`units `. Thus you can only use these pair styles with real units. These potentials do not yet calculate per-atom energy or virial @@ -237,11 +237,11 @@ none .. _amoeba-Ponder: -**(Ponder)** Ponder, Wu, Ren, Pande, Chodera†, Schnieders, Haque, Mobley, Lambrecht, DiStasio Jr, M. Head-Gordon, Clark, Johnson, T. Head-Gordon, J Phys Chem B, 114, 2549–2564 (2010). +**(Ponder)** Ponder, Wu, Ren, Pande, Chodera, Schnieders, Haque, Mobley, Lambrecht, DiStasio Jr, M. Head-Gordon, Clark, Johnson, T. Head-Gordon, J Phys Chem B, 114, 2549-2564 (2010). -.. _amobea-Rackers: +.. _amoeba-Rackers: -**(Rackers)** Rackers, Silva, Wang, Ponder, J Chem Theory Comput, 17, 7056–7084 (2021). +**(Rackers)** Rackers, Silva, Wang, Ponder, J Chem Theory Comput, 17, 7056-7084 (2021). .. _amoeba-Ren: @@ -249,5 +249,5 @@ none .. _amoeba-Shi: -**(Shi)** Shi, Xiz, Znahg, Best, Wu, Ponder, Ren, J Chem Theory Comp, 9, 4046, 2013. +**(Shi)** Shi, Xia, Zhang, Best, Wu, Ponder, Ren, J Chem Theory Comp, 9, 4046, 2013. diff --git a/doc/utils/sphinx-config/false_positives.txt b/doc/utils/sphinx-config/false_positives.txt index 77a1da6643..d5cd578da0 100644 --- a/doc/utils/sphinx-config/false_positives.txt +++ b/doc/utils/sphinx-config/false_positives.txt @@ -269,6 +269,7 @@ binutils biomolecular biomolecule Biomolecules +biomolecules Biophys Biosym biquadratic @@ -278,6 +279,7 @@ Bispectrum bitbucket bitmapped bitmask +bitorsion bitrate bitrates Bitzek @@ -443,6 +445,7 @@ chiralIDs ChiralIDs chirality Cho +Chodera ChooseOffset chris Christoph @@ -577,6 +580,7 @@ cstring cstyle csvr ctrl +ctrn ctypes Ctypes cuda @@ -697,6 +701,7 @@ devel Devemy deviatoric Devine +dewald df dfftw DFT @@ -774,6 +779,7 @@ DPD dpdTheta dphi DPhil +dpme dr dR dragforce @@ -1277,6 +1283,7 @@ gzipped Haak Hafskjold halfstepback +halgren Halperin Halver Hamaker @@ -1284,6 +1291,7 @@ Hamel Hammerschmidt Hanley haptic +Haque Hara Harpertown Harting @@ -1627,6 +1635,7 @@ Kemper kepler keV Keyes +keyfile Khersonskii Khrapak Khvostov @@ -1702,6 +1711,7 @@ Ladd lagrangian lambdai LambdaLanczos +Lambrecht lamda lammps Lammps @@ -2087,6 +2097,7 @@ mlparks Mniszewski mnt mobi +Mobley modc Modell modelled @@ -2137,6 +2148,7 @@ mpiexec mpiio mpirun mplayer +mpole mps mradius Mrovec @@ -2171,6 +2183,7 @@ multicore multielectron multinode multiphysics +Multipole multiscale multisectioning multithreading @@ -2358,6 +2371,7 @@ nodesets Noehring Noffset noforce +noguess Noid nolib nonequilibrium @@ -2366,6 +2380,7 @@ nonGaussian nonlocal Nonlocal Noordhoek +noprecond nopreliminary Nord norder @@ -2542,6 +2557,7 @@ palegreen paleturquoise palevioletred Panagiotopoulos +Pande Pandit Papaconstantopoulos papayawhip @@ -2576,6 +2592,7 @@ Pavia Paxton pbc pc +pcg pchain Pchain pcmoves @@ -2609,7 +2626,9 @@ Persp peru Peskin Pettifor +pewald pfactor +pflag pgi ph Philipp @@ -2642,6 +2661,7 @@ pIp Pisarev Pishevar Pitera +pitorsion pj pjintve pKa @@ -2657,6 +2677,7 @@ plt plumedfile pmb pmcmoves +pme Pmolrotate Pmoltrans pN @@ -2681,6 +2702,7 @@ polyelectrolyte polyhedra Polym polymorphism +Ponder popen Popoola Popov @@ -2699,6 +2721,7 @@ potin Pourtois powderblue PowerShell +ppme ppn pppm Prakash @@ -2708,6 +2731,7 @@ pre Pre prec precession +precond prefactor prefactors prepend @@ -2802,6 +2826,8 @@ Qsb qtb quadratically quadrupolar +quadrupole +quadrupoles Quant quartic quat @@ -2818,6 +2844,7 @@ qw qx qy qz +Rackers radialscreened radialscreenedspin radialspin @@ -3057,6 +3084,7 @@ Schimansky Schiotz Schlitter Schmid +Schnieders Schoen Schotte Schratt @@ -3513,6 +3541,9 @@ Tz Tzou ub Uberuaga +ubflag +Ubflag +ubiquitin uca uChem uCond @@ -3566,12 +3597,14 @@ upenn upto Urbakh Urbana +UreyBradley Usabiaga usec uSemiParallel userguide username usleep +usolve usr util utils @@ -3605,6 +3638,7 @@ Vcm vdfmax vdim vdisplace +vdw vdW vdwl vec @@ -3758,6 +3792,7 @@ Xeon xflag xhi xHost +Xia Xiaohu Xiaowang Xie From 7229c4eb437670aa6e5471be7fbaa6997ed35440 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 5 Jul 2022 00:02:37 -0400 Subject: [PATCH 527/585] refactored file parsing --- src/AMOEBA/amoeba_file.cpp | 1377 +++++++++++++++++++----------------- src/AMOEBA/pair_amoeba.h | 40 +- 2 files changed, 732 insertions(+), 685 deletions(-) diff --git a/src/AMOEBA/amoeba_file.cpp b/src/AMOEBA/amoeba_file.cpp index b4b6726838..77ea3ed774 100644 --- a/src/AMOEBA/amoeba_file.cpp +++ b/src/AMOEBA/amoeba_file.cpp @@ -20,6 +20,7 @@ #include "force.h" #include "memory.h" #include "utils.h" +#include "tokenizer.h" #include #include @@ -27,9 +28,9 @@ using namespace LAMMPS_NS; -enum{FFIELD,LITERATURE,ATOMTYPE,VDWL,VDWLPAIR,BSTRETCH,SBEND,ABEND, +enum{UNKNOWN,FFIELD,LITERATURE,ATOMTYPE,VDWL,VDWLPAIR,BSTRETCH,SBEND,ABEND, PAULI,DISPERSION,UB,OUTPLANE,TORSION,PITORSION,ATOMMULT, - QPENETRATION,DIPPOLAR,QTRANSFER,UNKNOWN,END_OF_FILE}; + QPENETRATION,DIPPOLAR,QTRANSFER,END_OF_FILE}; enum{ALLINGER,BUFFERED_14_7}; enum{ARITHMETIC,GEOMETRIC,CUBIC_MEAN,R_MIN,SIGMA,DIAMETER,HARMONIC,HHG,W_H}; enum{MUTUAL,OPT,TCG,DIRECT}; @@ -77,18 +78,17 @@ void PairAmoeba::set_defaults() void PairAmoeba::read_prmfile(char *filename) { - int n,nextflag; - // open potential file int me = comm->me; FILE *fptr; - char line[MAXLINE],next[MAXLINE]; + char line[MAXLINE]; if (me == 0) { - fptr = utils::open_potential(filename,lmp,nullptr); - if (fptr == nullptr) error->one(FLERR, "Cannot open {} PRM file {}: {}", - utils::uppercase(mystyle), filename, utils::getsyserror()); + fptr = utils::open_potential(filename, lmp, nullptr); + if (fptr == nullptr) + error->one(FLERR, "Cannot open {} PRM file {}: {}", utils::uppercase(mystyle), filename, + utils::getsyserror()); } // read sections, one at a time @@ -97,8 +97,8 @@ void PairAmoeba::read_prmfile(char *filename) // Atom Type Definitions must come before any other section // other sections can follow in any order - int forcefield_flag = 0; - int atomtype_flag = 0; + bool forcefield_flag = false; + bool atomtype_flag = false; int section; int nline = 0; @@ -110,27 +110,45 @@ void PairAmoeba::read_prmfile(char *filename) ++nline; if (utils::strmatch(line, "^\\s*##\\s+\\S+.*##\\s*$")) { auto trimmed = utils::trim(line); - if (utils::strmatch(trimmed, "^##\\s*Force Field")) section = FFIELD; - else if (utils::strmatch(trimmed, "^##\\s*Literature")) section = LITERATURE; - else if (utils::strmatch(trimmed, "^##\\s*Atom Type")) section = ATOMTYPE; - else if (utils::strmatch(trimmed, "^##\\s*Van der Waals Param")) section = VDWL; - else if (utils::strmatch(trimmed, "^##\\s*Van der Waals Pair")) section = VDWLPAIR; - else if (utils::strmatch(trimmed, "^##\\s*Bond Stretching")) section = BSTRETCH; - else if (utils::strmatch(trimmed, "^##\\s*Stretch-Bend")) section = SBEND; - else if (utils::strmatch(trimmed, "^##\\s*Angle Bending")) section = ABEND; - else if (utils::strmatch(trimmed, "^##\\s*Pauli Repulsion")) section = PAULI; - else if (utils::strmatch(trimmed, "^##\\s*Dispersion Param")) section = DISPERSION; - else if (utils::strmatch(trimmed, "^##\\s*Urey-Bradley")) section = UB; - else if (utils::strmatch(trimmed, "^##\\s*Out-of-Plane")) section = OUTPLANE; - else if (utils::strmatch(trimmed, "^##\\s*Torsional")) section = TORSION; - else if (utils::strmatch(trimmed, "^##\\s*Pi-Torsion")) section = PITORSION; - else if (utils::strmatch(trimmed, "^##\\s*Atomic Multipole")) section = ATOMMULT; - else if (utils::strmatch(trimmed, "^##\\s*Charge Penetration")) section = QPENETRATION; - else if (utils::strmatch(trimmed, "^##\\s*Dipole Polarizability")) section = DIPPOLAR; - else if (utils::strmatch(trimmed, "^##\\s*Charge Transfer")) section = QTRANSFER; + if (utils::strmatch(trimmed, "^##\\s*Force Field")) + section = FFIELD; + else if (utils::strmatch(trimmed, "^##\\s*Literature")) + section = LITERATURE; + else if (utils::strmatch(trimmed, "^##\\s*Atom Type")) + section = ATOMTYPE; + else if (utils::strmatch(trimmed, "^##\\s*Van der Waals Param")) + section = VDWL; + else if (utils::strmatch(trimmed, "^##\\s*Van der Waals Pair")) + section = VDWLPAIR; + else if (utils::strmatch(trimmed, "^##\\s*Bond Stretching")) + section = BSTRETCH; + else if (utils::strmatch(trimmed, "^##\\s*Stretch-Bend")) + section = SBEND; + else if (utils::strmatch(trimmed, "^##\\s*Angle Bending")) + section = ABEND; + else if (utils::strmatch(trimmed, "^##\\s*Pauli Repulsion")) + section = PAULI; + else if (utils::strmatch(trimmed, "^##\\s*Dispersion Param")) + section = DISPERSION; + else if (utils::strmatch(trimmed, "^##\\s*Urey-Bradley")) + section = UB; + else if (utils::strmatch(trimmed, "^##\\s*Out-of-Plane")) + section = OUTPLANE; + else if (utils::strmatch(trimmed, "^##\\s*Torsional")) + section = TORSION; + else if (utils::strmatch(trimmed, "^##\\s*Pi-Torsion")) + section = PITORSION; + else if (utils::strmatch(trimmed, "^##\\s*Atomic Multipole")) + section = ATOMMULT; + else if (utils::strmatch(trimmed, "^##\\s*Charge Penetration")) + section = QPENETRATION; + else if (utils::strmatch(trimmed, "^##\\s*Dipole Polarizability")) + section = DIPPOLAR; + else if (utils::strmatch(trimmed, "^##\\s*Charge Transfer")) + section = QTRANSFER; else { section = UNKNOWN; - utils::logmesg(lmp, "Skipping section: {}\n", trimmed.substr(2,trimmed.size()-4)); + utils::logmesg(lmp, "Skipping section: {}\n", trimmed.substr(2, trimmed.size() - 4)); } // skip two lines following section head keyword @@ -141,71 +159,159 @@ void PairAmoeba::read_prmfile(char *filename) } } if (ferror(fptr)) - error->one(FLERR, "Problem reading {} PRM file {}:{} {}", - utils::uppercase(mystyle), nline, filename, utils::getsyserror()); + error->one(FLERR, "Problem reading {} PRM file {}:{} {}", utils::uppercase(mystyle), nline, + filename, utils::getsyserror()); if (feof(fptr)) section = END_OF_FILE; } MPI_Bcast(§ion, 1, MPI_INT, 0, world); if (section == END_OF_FILE) break; // sanity checks - if ((forcefield_flag == 0) && (section != FFIELD)) - error->all(FLERR,"Force Field is not first section of pair {} potential file", mystyle); + if (!forcefield_flag && (section != FFIELD)) + error->all(FLERR, "Force Field is not first section of pair {} potential file", mystyle); - if ((section != FFIELD) && (section != LITERATURE) && (section != ATOMTYPE) && - (section != UNKNOWN) && (atomtype_flag == 0)) - error->all(FLERR,"Atom Type section of pair {} potential file must " - "come before all but the Force Field section", mystyle); + if ((section > ATOMTYPE) && !atomtype_flag) + error->all(FLERR, + "Atom Type section of pair {} potential file must " + "come before all but the Force Field section", + mystyle); - if (section == FFIELD) forcefield_flag = 1; - if (section == ATOMTYPE) atomtype_flag = 1; + if (section == FFIELD) forcefield_flag = true; + if (section == ATOMTYPE) atomtype_flag = true; if (section == ATOMMULT) { for (int i = 1; i <= n_amtype; i++) nmultiframe[i] = 0; } - nextflag = 0; - + char next[MAXLINE]; + next[0] = '\0'; + bool has_next = false; + int n; while (true) { - if (me == 0) n = read_section_line(fptr,line,nextflag,next); - MPI_Bcast(&n,1,MPI_INT,0,world); - if (n < 0) break; - MPI_Bcast(line,n+1,MPI_CHAR,0,world); + if (me == 0) { + while (true) { + line[0] = '\0'; + n = -1; + if (has_next) strcpy(line, next); + has_next = false; + clearerr(fptr); + while (fgets(next, MAXLINE, fptr)) { + ++nline; + auto trimmed = utils::trim(next); + // chop off !! comments + std::size_t pos = trimmed.find("!!"); + if (pos != std::string::npos) trimmed = trimmed.substr(0, pos); - // line starting with #### = next section line + // append to line if next line starts with a number + if (utils::is_double(utils::strfind(trimmed, "^\\S+"))) { + strcat(line, " "); + strcat(line, trimmed.c_str()); + has_next = false; + } else { + strcpy(next, trimmed.c_str()); + has_next = true; + break; + } + } + if (ferror(fptr)) + error->one(FLERR, "Problem reading {} PRM file {}:{} {}", utils::uppercase(mystyle), + nline, filename, utils::getsyserror()); + + auto trimmed = utils::trim(line); + + // start of next section + if (utils::strmatch(trimmed, "^####+$")) { + n = 0; + break; + } + + // skip concatenated line with commented out keyword + if (utils::strmatch(trimmed, "^#\\w+")) continue; + + // exit loop if line is not empty + if (!trimmed.empty()) { + strcpy(line, trimmed.c_str()); + n = strlen(line) + 1; + break; + } + if (feof(fptr)) { + n = -1; + break; + } + } + } + MPI_Bcast(&n, 1, MPI_INT, 0, world); + if (n < 0) break; + MPI_Bcast(line, n, MPI_CHAR, 0, world); + + // next section if (n == 0) break; - // convert all chars in line to lower-case + // convert line to lowercase and get list of words + // XXX do we need to use lowercase? Preserving case may be useful later for type lables. + // XXX We could also use utils::split_words() which slower but can handle quotes. + auto words = Tokenizer(utils::lowercase(line)).as_vector(); - for (int i = 0; i < n; i++) - line[i] = tolower(line[i]); - - char *copy; - char **words; - int nwords = tokenize(line,words,copy); - - if (section == FFIELD) file_ffield(nwords,words); - else if (section == LITERATURE) file_literature(nwords,words); - else if (section == ATOMTYPE) file_atomtype(nwords,words); - else if (section == VDWL) file_vdwl(nwords,words); - else if (section == VDWLPAIR) file_vdwl_pair(nwords,words); - else if (section == BSTRETCH) file_bstretch(nwords,words); - else if (section == SBEND) file_sbend(nwords,words); - else if (section == ABEND) file_abend(nwords,words); - else if (section == PAULI) file_pauli(nwords,words); - else if (section == DISPERSION) file_dispersion(nwords,words); - else if (section == UB) file_ub(nwords,words); - else if (section == OUTPLANE) file_outplane(nwords,words); - else if (section == TORSION) file_torsion(nwords,words); - else if (section == PITORSION) file_pitorsion(nwords,words); - else if (section == ATOMMULT) file_multipole(nwords,words); - else if (section == QPENETRATION) file_charge_penetration(nwords,words); - else if (section == DIPPOLAR) file_dippolar(nwords,words); - else if (section == QTRANSFER) file_charge_transfer(nwords,words); - else if (section == UNKNOWN) {} - - delete[] copy; - delete[] words; + switch (section) { + case FFIELD: + file_ffield(words, nline - 1); + break; + case LITERATURE: + file_literature(words, nline - 1); + break; + case ATOMTYPE: + file_atomtype(words, nline - 1); + break; + case VDWL: + file_vdwl(words, nline - 1); + break; + case VDWLPAIR: + file_vdwl_pair(words, nline - 1); + break; + case BSTRETCH: + file_bstretch(words, nline - 1); + break; + case SBEND: + file_sbend(words, nline - 1); + break; + case ABEND: + file_abend(words, nline - 1); + break; + case PAULI: + file_pauli(words, nline - 1); + break; + case DISPERSION: + file_dispersion(words, nline - 1); + break; + case UB: + file_ub(words, nline - 1); + break; + case OUTPLANE: + file_outplane(words, nline - 1); + break; + case TORSION: + file_torsion(words, nline - 1); + break; + case PITORSION: + file_pitorsion(words, nline - 1); + break; + case ATOMMULT: + file_multipole(words, nline - 1); + break; + case QPENETRATION: + file_charge_penetration(words, nline - 1); + break; + case DIPPOLAR: + file_dippolar(words, nline - 1); + break; + case QTRANSFER: + file_charge_transfer(words, nline - 1); + break; + case UNKNOWN: + case END_OF_FILE: + default: + ; // do nothing + } } if (n < 0) break; @@ -214,7 +320,7 @@ void PairAmoeba::read_prmfile(char *filename) if (me == 0) fclose(fptr); if (forcefield_flag == 0 || atomtype_flag == 0) - error->all(FLERR,"Pair amoeba potential file incomplete"); + error->all(FLERR, "Pair {} potential file {} incomplete", mystyle, filename); } /* ---------------------------------------------------------------------- @@ -223,7 +329,7 @@ void PairAmoeba::read_prmfile(char *filename) void PairAmoeba::read_keyfile(char *filename) { - double aprd,bprd,cprd; + double aprd, bprd, cprd; // default settings for which there are keyword options @@ -280,61 +386,62 @@ void PairAmoeba::read_keyfile(char *filename) FILE *fptr; char line[MAXLINE]; if (me == 0) { - fptr = utils::open_potential(filename,lmp,nullptr); + fptr = utils::open_potential(filename, lmp, nullptr); if (fptr == nullptr) - error->one(FLERR,"Cannot open AMOEBA key file {}: {}",filename, utils::getsyserror()); + error->one(FLERR, "Cannot open {} key file {}: {}", utils::uppercase(mystyle), filename, + utils::getsyserror()); } // read lines, one at a time int n; - char *ptr,*keyword; + char *ptr; while (true) { if (me == 0) { - ptr = fgets(line,MAXLINE,fptr); - if (!ptr) n = -1; - else n = strlen(line); + ptr = fgets(line, MAXLINE, fptr); + if (!ptr) + n = -1; + else + n = strlen(line) + 1; } - MPI_Bcast(&n,1,MPI_INT,0,world); + MPI_Bcast(&n, 1, MPI_INT, 0, world); if (n < 0) break; - MPI_Bcast(line,n+1,MPI_CHAR,0,world); - if (strspn(line," \t\n\r") == strlen(line)) continue; + MPI_Bcast(line, n, MPI_CHAR, 0, world); - // convert all chars in line to lower-case + // skip over empty or comment lines + auto trimmed = utils::lowercase(utils::trim(line)); + if (trimmed.empty() || utils::strmatch(trimmed, "^#") || utils::strmatch(trimmed, "!!")) + continue; - for (int i = 0; i < n; i++) - line[i] = tolower(line[i]); + const auto words = Tokenizer(trimmed).as_vector(); + const int nwords = words.size(); + const auto keyword = words[0]; - char *copy; - char **words; - int nwords = tokenize(line,words,copy); - keyword = words[0]; + if (utils::strmatch(keyword, "^[^a-z]+")) { + ; // ignore keywords that do not start with text + } else if (keyword == "a-axis") { + if (nwords != 2) error->all(FLERR, "AMOEBA keyfile line is invalid"); + aprd = utils::numeric(FLERR, words[1], false, lmp); + } else if (keyword == "b-axis") { + if (nwords != 2) error->all(FLERR, "AMOEBA keyfile line is invalid"); + bprd = utils::numeric(FLERR, words[1], false, lmp); + } else if (keyword == "c-axis") { + if (nwords != 2) error->all(FLERR, "AMOEBA keyfile line is invalid"); + cprd = utils::numeric(FLERR, words[1], false, lmp); - if (strstr(keyword,"#") || strstr(keyword,"!!") || !isalpha(keyword[0])) { - - } else if (strcmp(keyword,"a-axis") == 0) { - if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); - aprd = utils::numeric(FLERR,words[1],true,lmp); - } else if (strcmp(keyword,"b-axis") == 0) { - if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); - bprd = utils::numeric(FLERR,words[1],true,lmp); - } else if (strcmp(keyword,"c-axis") == 0) { - if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); - cprd = utils::numeric(FLERR,words[1],true,lmp); - - } else if (strcmp(keyword,"cutoff") == 0) { - if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); - double cut = utils::numeric(FLERR,words[1],true,lmp); + } else if (keyword == "cutoff") { + if (nwords != 2) error->all(FLERR, "AMOEBA keyfile line is invalid"); + double cut = utils::numeric(FLERR, words[1], false, lmp); vdwcut = repcut = dispcut = mpolecut = ctrncut = ewaldcut = dewaldcut = cut; vdwtaper = 0.9 * vdwcut; reptaper = 0.9 * repcut; disptaper = 0.9 * dispcut; mpoletaper = 0.65 * mpolecut; ctrntaper = 0.9 * ctrncut; - } else if (strcmp(keyword,"taper") == 0) { - if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); - double taper = utils::numeric(FLERR,words[1],true,lmp); + } else if (keyword == "taper") { + if (nwords != 2) error->all(FLERR, "AMOEBA keyfile line is invalid"); + double taper = utils::numeric(FLERR, words[1], false, lmp); if (taper >= 1.0) { vdwtaper = reptaper = disptaper = mpoletaper = ctrntaper = taper; } else { @@ -345,189 +452,189 @@ void PairAmoeba::read_keyfile(char *filename) mpoletaper = taper * mpolecut; ctrntaper = taper * ctrncut; } - } else if (strcmp(keyword,"vdw-cutoff") == 0) { - if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); - vdwcut = utils::numeric(FLERR,words[1],true,lmp); + } else if (keyword == "vdw-cutoff") { + if (nwords != 2) error->all(FLERR, "AMOEBA keyfile line is invalid"); + vdwcut = utils::numeric(FLERR, words[1], false, lmp); vdwtaper = 0.9 * vdwcut; - } else if (strcmp(keyword,"repulsion-cutoff") == 0) { - if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); - repcut = utils::numeric(FLERR,words[1],true,lmp); + } else if (keyword == "repulsion-cutoff") { + if (nwords != 2) error->all(FLERR, "AMOEBA keyfile line is invalid"); + repcut = utils::numeric(FLERR, words[1], false, lmp); reptaper = 0.9 * repcut; - } else if (strcmp(keyword,"dispersion-cutoff") == 0) { - if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); - dispcut = utils::numeric(FLERR,words[1],true,lmp); + } else if (keyword == "dispersion-cutoff") { + if (nwords != 2) error->all(FLERR, "AMOEBA keyfile line is invalid"); + dispcut = utils::numeric(FLERR, words[1], false, lmp); disptaper = 0.9 * dispcut; - } else if (strcmp(keyword,"mpole-cutoff") == 0) { - if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); - mpolecut = utils::numeric(FLERR,words[1],true,lmp); + } else if (keyword == "mpole-cutoff") { + if (nwords != 2) error->all(FLERR, "AMOEBA keyfile line is invalid"); + mpolecut = utils::numeric(FLERR, words[1], false, lmp); mpoletaper = 0.65 * mpolecut; - } else if (strcmp(keyword,"ctrn-cutoff") == 0) { - if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); - ctrncut = utils::numeric(FLERR,words[1],true,lmp); + } else if (keyword == "ctrn-cutoff") { + if (nwords != 2) error->all(FLERR, "AMOEBA keyfile line is invalid"); + ctrncut = utils::numeric(FLERR, words[1], false, lmp); ctrntaper = 0.9 * ctrncut; - } else if (strcmp(keyword,"ewald-cutoff") == 0) { - if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); - ewaldcut = utils::numeric(FLERR,words[1],true,lmp); - } else if (strcmp(keyword,"dewald-cutoff") == 0) { - if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); - dewaldcut = utils::numeric(FLERR,words[1],true,lmp); - } else if (strcmp(keyword,"usolve-cutoff") == 0) { - if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); - usolvcut = utils::numeric(FLERR,words[1],true,lmp); - } else if (strcmp(keyword,"usolve-diag") == 0) { - if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); - udiag = utils::numeric(FLERR,words[1],true,lmp); + } else if (keyword == "ewald-cutoff") { + if (nwords != 2) error->all(FLERR, "AMOEBA keyfile line is invalid"); + ewaldcut = utils::numeric(FLERR, words[1], false, lmp); + } else if (keyword == "dewald-cutoff") { + if (nwords != 2) error->all(FLERR, "AMOEBA keyfile line is invalid"); + dewaldcut = utils::numeric(FLERR, words[1], false, lmp); + } else if (keyword == "usolve-cutoff") { + if (nwords != 2) error->all(FLERR, "AMOEBA keyfile line is invalid"); + usolvcut = utils::numeric(FLERR, words[1], false, lmp); + } else if (keyword == "usolve-diag") { + if (nwords != 2) error->all(FLERR, "AMOEBA keyfile line is invalid"); + udiag = utils::numeric(FLERR, words[1], false, lmp); - } else if (strcmp(keyword,"vdw-taper") == 0) { - if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); - vdwtaper = utils::numeric(FLERR,words[1],true,lmp); + } else if (keyword == "vdw-taper") { + if (nwords != 2) error->all(FLERR, "AMOEBA keyfile line is invalid"); + vdwtaper = utils::numeric(FLERR, words[1], false, lmp); if (vdwtaper < 1.0) vdwtaper = -vdwtaper * vdwcut; - } else if (strcmp(keyword,"repulsion-taper") == 0) { - if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); - reptaper = utils::numeric(FLERR,words[1],true,lmp); + } else if (keyword == "repulsion-taper") { + if (nwords != 2) error->all(FLERR, "AMOEBA keyfile line is invalid"); + reptaper = utils::numeric(FLERR, words[1], false, lmp); if (reptaper < 1.0) reptaper = -reptaper * repcut; - } else if (strcmp(keyword,"dispersion-taper") == 0) { - if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); - disptaper = utils::numeric(FLERR,words[1],true,lmp); + } else if (keyword == "dispersion-taper") { + if (nwords != 2) error->all(FLERR, "AMOEBA keyfile line is invalid"); + disptaper = utils::numeric(FLERR, words[1], false, lmp); if (disptaper < 1.0) disptaper = -disptaper * vdwcut; - } else if (strcmp(keyword,"mpole-taper") == 0) { - if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); - mpoletaper = utils::numeric(FLERR,words[1],true,lmp); + } else if (keyword == "mpole-taper") { + if (nwords != 2) error->all(FLERR, "AMOEBA keyfile line is invalid"); + mpoletaper = utils::numeric(FLERR, words[1], false, lmp); if (mpoletaper < 1.0) mpoletaper = -mpoletaper * vdwcut; - } else if (strcmp(keyword,"ctrn-taper") == 0) { - if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); - ctrntaper = utils::numeric(FLERR,words[1],true,lmp); + } else if (keyword == "ctrn-taper") { + if (nwords != 2) error->all(FLERR, "AMOEBA keyfile line is invalid"); + ctrntaper = utils::numeric(FLERR, words[1], false, lmp); if (ctrntaper < 1.0) ctrntaper = -ctrntaper * vdwcut; - } else if (strcmp(keyword,"delta-halgren") == 0) { - if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); - dhal = utils::numeric(FLERR,words[1],true,lmp); - } else if (strcmp(keyword,"gamma-halgren") == 0) { - if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); - ghal = utils::numeric(FLERR,words[1],true,lmp); + } else if (keyword == "delta-halgren") { + if (nwords != 2) error->all(FLERR, "AMOEBA keyfile line is invalid"); + dhal = utils::numeric(FLERR, words[1], false, lmp); + } else if (keyword == "gamma-halgren") { + if (nwords != 2) error->all(FLERR, "AMOEBA keyfile line is invalid"); + ghal = utils::numeric(FLERR, words[1], false, lmp); - } else if (strcmp(keyword,"ewald") == 0) { - if (nwords != 1) error->all(FLERR,"AMOEBA keyfile line is invalid"); + } else if (keyword == "ewald") { + if (nwords != 1) error->all(FLERR, "AMOEBA keyfile line is invalid"); use_ewald = 1; - } else if (strcmp(keyword,"dewald") == 0) { - if (nwords != 1) error->all(FLERR,"AMOEBA keyfile line is invalid"); + } else if (keyword == "dewald") { + if (nwords != 1) error->all(FLERR, "AMOEBA keyfile line is invalid"); use_dewald = 1; - } else if (strcmp(keyword,"pme-order") == 0) { - if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); - bseorder = utils::numeric(FLERR,words[1],true,lmp); - } else if (strcmp(keyword,"ppme-order") == 0) { - if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); - bsporder = utils::numeric(FLERR,words[1],true,lmp); - } else if (strcmp(keyword,"dpme-order") == 0) { - if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); - bsdorder = utils::numeric(FLERR,words[1],true,lmp); + } else if (keyword == "pme-order") { + if (nwords != 2) error->all(FLERR, "AMOEBA keyfile line is invalid"); + bseorder = utils::numeric(FLERR, words[1], false, lmp); + } else if (keyword == "ppme-order") { + if (nwords != 2) error->all(FLERR, "AMOEBA keyfile line is invalid"); + bsporder = utils::numeric(FLERR, words[1], false, lmp); + } else if (keyword == "dpme-order") { + if (nwords != 2) error->all(FLERR, "AMOEBA keyfile line is invalid"); + bsdorder = utils::numeric(FLERR, words[1], false, lmp); - } else if (strcmp(keyword,"pme-grid") == 0) { - if (nwords != 2 && nwords != 4) - error->all(FLERR,"AMOEBA keyfile line is invalid"); + } else if (keyword == "pme-grid") { + if (nwords != 2 && nwords != 4) error->all(FLERR, "AMOEBA keyfile line is invalid"); if (nwords == 2) - nefft1 = nefft2 = nefft3 = utils::numeric(FLERR,words[1],true,lmp); + nefft1 = nefft2 = nefft3 = utils::numeric(FLERR, words[1], false, lmp); else { - nefft1 = utils::numeric(FLERR,words[1],true,lmp); - nefft2 = utils::numeric(FLERR,words[2],true,lmp); - nefft3 = utils::numeric(FLERR,words[3],true,lmp); + nefft1 = utils::numeric(FLERR, words[1], false, lmp); + nefft2 = utils::numeric(FLERR, words[2], false, lmp); + nefft3 = utils::numeric(FLERR, words[3], false, lmp); } pmegrid_key = 1; - } else if (strcmp(keyword,"dpme-grid") == 0) { - if (nwords != 2 && nwords != 4) - error->all(FLERR,"AMOEBA keyfile line is invalid"); + } else if (keyword == "dpme-grid") { + if (nwords != 2 && nwords != 4) error->all(FLERR, "AMOEBA keyfile line is invalid"); if (nwords == 2) - ndfft1 = ndfft2 = ndfft3 = utils::numeric(FLERR,words[1],true,lmp); + ndfft1 = ndfft2 = ndfft3 = utils::numeric(FLERR, words[1], false, lmp); else { - ndfft1 = utils::numeric(FLERR,words[1],true,lmp); - ndfft2 = utils::numeric(FLERR,words[2],true,lmp); - ndfft3 = utils::numeric(FLERR,words[3],true,lmp); + ndfft1 = utils::numeric(FLERR, words[1], false, lmp); + ndfft2 = utils::numeric(FLERR, words[2], false, lmp); + ndfft3 = utils::numeric(FLERR, words[3], false, lmp); } dpmegrid_key = 1; - } else if (strcmp(keyword,"ewald-alpha") == 0) { - if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); - aeewald = utils::numeric(FLERR,words[1],true,lmp); + } else if (keyword == "ewald-alpha") { + if (nwords != 2) error->all(FLERR, "AMOEBA keyfile line is invalid"); + aeewald = utils::numeric(FLERR, words[1], false, lmp); aeewald_key = 1; - } else if (strcmp(keyword,"pewald-alpha") == 0) { - if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); - apewald = utils::numeric(FLERR,words[1],true,lmp); + } else if (keyword == "pewald-alpha") { + if (nwords != 2) error->all(FLERR, "AMOEBA keyfile line is invalid"); + apewald = utils::numeric(FLERR, words[1], false, lmp); apewald_key = 1; - } else if (strcmp(keyword,"dewald-alpha") == 0) { - if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); - adewald = utils::numeric(FLERR,words[1],true,lmp); + } else if (keyword == "dewald-alpha") { + if (nwords != 2) error->all(FLERR, "AMOEBA keyfile line is invalid"); + adewald = utils::numeric(FLERR, words[1], false, lmp); adewald_key = 1; - // polarization options + // polarization options - } else if (strcmp(words[0],"polarization") == 0) { - if (strcmp(words[1],"mutual") == 0) poltyp = MUTUAL; - else if (strstr(words[1],"opt") == words[1]) { + } else if (keyword == "polarization") { + if (words[1] == "mutual") + poltyp = MUTUAL; + else if (utils::strmatch(words[1], "^opt")) { poltyp = OPT; - if (strcmp(words[1],"opt") == 0) optorder = 4; - else optorder = utils::inumeric(FLERR,&words[1][3],true,lmp); + if (words[1] == "opt") + optorder = 4; + else + optorder = utils::inumeric(FLERR, &words[1][3], false, lmp); if (optorder < 1 || optorder > 6) - error->all(FLERR,"Unrecognized polarization OPTn in AMOEBA FF file"); - } else if (strcmp(words[1],"tcg") == 0) - error->all(FLERR,"Polarization TCG not yet supported in AMOEBA/HIPPO"); - else if (strcmp(words[1],"direct") == 0) poltyp = DIRECT; - else error->all(FLERR,"Unrecognized polarization in AMOEBA FF file"); + error->all(FLERR, "Unrecognized polarization OPT{} in AMOEBA FF file", optorder); + } else if (words[1] == "tcg") + error->all(FLERR, "Polarization TCG not yet supported in AMOEBA/HIPPO"); + else if (words[1] == "direct") + poltyp = DIRECT; + else + error->all(FLERR, "Unrecognized polarization in AMOEBA FF file"); - } else if (strcmp(keyword,"polar-predict") == 0) { - if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); - if (strcmp(words[1],"gear") == 0) { + } else if (keyword == "polar-predict") { + if (nwords != 2) error->all(FLERR, "AMOEBA keyfile line is invalid"); + if (words[1] == "gear") { polpred = GEAR; maxualt = 7; - } else if (strcmp(words[1],"aspc") == 0) { + } else if (words[1] == "aspc") { polpred = ASPC; maxualt = 17; - } else if (strcmp(words[1],"lsqr") == 0) { + } else if (words[1] == "lsqr") { polpred = LSQR; maxualt = 7; - } else error->all(FLERR,"AMOEBA keyfile line is invalid"); + } else + error->all(FLERR, "AMOEBA keyfile line is invalid"); use_pred = 1; - } else if (strcmp(keyword,"polar-iter") == 0) { - if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); - politer = utils::inumeric(FLERR,words[1],true,lmp); - } else if (strcmp(keyword,"polar-eps") == 0) { - if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); - poleps = utils::numeric(FLERR,words[1],true,lmp); + } else if (keyword == "polar-iter") { + if (nwords != 2) error->all(FLERR, "AMOEBA keyfile line is invalid"); + politer = utils::inumeric(FLERR, words[1], false, lmp); + } else if (keyword == "polar-eps") { + if (nwords != 2) error->all(FLERR, "AMOEBA keyfile line is invalid"); + poleps = utils::numeric(FLERR, words[1], false, lmp); - } else if (strcmp(keyword,"pcg-precond") == 0) { - if (nwords != 1) error->all(FLERR,"AMOEBA keyfile line is invalid"); + } else if (keyword == "pcg-precond") { + if (nwords != 1) error->all(FLERR, "AMOEBA keyfile line is invalid"); pcgprec = 1; - } else if (strcmp(keyword,"pcg-noprecond") == 0) { - if (nwords != 1) error->all(FLERR,"AMOEBA keyfile line is invalid"); + } else if (keyword == "pcg-noprecond") { + if (nwords != 1) error->all(FLERR, "AMOEBA keyfile line is invalid"); pcgprec = 0; - } else if (strcmp(keyword,"pcg-guess") == 0) { - if (nwords != 1) error->all(FLERR,"AMOEBA keyfile line is invalid"); + } else if (keyword == "pcg-guess") { + if (nwords != 1) error->all(FLERR, "AMOEBA keyfile line is invalid"); pcgguess = 1; - } else if (strcmp(keyword,"pcg-noguess") == 0) { - if (nwords != 1) error->all(FLERR,"AMOEBA keyfile line is invalid"); + } else if (keyword == "pcg-noguess") { + if (nwords != 1) error->all(FLERR, "AMOEBA keyfile line is invalid"); pcgguess = 0; - } else if (strcmp(keyword,"pcg-peek") == 0) { - if (nwords != 2) error->all(FLERR,"AMOEBA keyfile line is invalid"); - pcgpeek = utils::numeric(FLERR,words[1],true,lmp); + } else if (keyword == "pcg-peek") { + if (nwords != 2) error->all(FLERR, "AMOEBA keyfile line is invalid"); + pcgpeek = utils::numeric(FLERR, words[1], false, lmp); - // Tinker keywords that LAMMPS can skip + // Tinker keywords that LAMMPS can skip - } else if (strcmp(keyword,"parameters") == 0) { - } else if (strcmp(keyword,"verbose") == 0) { - } else if (strcmp(keyword,"openmp-threads") == 0) { - } else if (strcmp(keyword,"digits") == 0) { - } else if (strcmp(keyword,"neighbor-list") == 0) { - } else if (strcmp(keyword,"tau-temperature") == 0) { - } else if (strcmp(keyword,"tau-pressure") == 0) { + } else if (keyword == "parameters") { + } else if (keyword == "verbose") { + } else if (keyword == "openmp-threads") { + } else if (keyword == "digits") { + } else if (keyword == "neighbor-list") { + } else if (keyword == "tau-temperature") { + } else if (keyword == "tau-pressure") { - // error if LAMMPS does not recognize other keywords + // error if LAMMPS does not recognize other keywords - } else error->all(FLERR, - "LAMMPS does not recognize AMOEBA keyfile keyword {}", - keyword); - - delete[] copy; - delete[] words; + } else + error->all(FLERR, "LAMMPS does not recognize AMOEBA keyfile keyword {}", keyword); } // close key file @@ -542,332 +649,229 @@ void PairAmoeba::read_keyfile(char *filename) // error checks if (use_ewald || use_dewald) { - if (domain->nonperiodic) - error->all(FLERR,"AMOEBA KSpace requires fully periodic system"); + if (domain->nonperiodic) error->all(FLERR, "AMOEBA KSpace requires fully periodic system"); } if (aprd > 0.0 && (!domain->xperiodic || domain->xprd != aprd)) - error->all(FLERR,"AMOEBA abc prd does not match LAMMPS domain"); + error->all(FLERR, "AMOEBA abc prd does not match LAMMPS domain"); if (bprd > 0.0 && (!domain->yperiodic || domain->yprd != bprd)) - error->all(FLERR,"AMOEBA abc prd does not match LAMMPS domain"); + error->all(FLERR, "AMOEBA abc prd does not match LAMMPS domain"); if (cprd > 0.0 && (!domain->zperiodic || domain->zprd != cprd)) - error->all(FLERR,"AMOEBA abc prd does not match LAMMPS domain"); + error->all(FLERR, "AMOEBA abc prd does not match LAMMPS domain"); } /* ---------------------------------------------------------------------- */ -int PairAmoeba::read_section_line(FILE *fp, char *line, - int &nextflag, char *next) +void PairAmoeba::file_ffield(const std::vector &words, int nline) { - // loop on read line - // if next line defined, use it instead of read - // return -1 if EOF - // skip line if blank - // tokenize - // if first word starts with ####, return 0 - // if first word starts with # or !!, continue - // append continuation lines to line - // until a line is blank, starts with #, starts with alpha char, or EOF - // save next line read, and set nextflag for next call - // return length of line + if (words.size() < 2) + error->all(FLERR, "Keyword {} without argument(s) in {} PRM file", words[0], mystyle); - char *ptr,*copy,*copy_next; - char **words,**words_next; - int nwords, nwords_next; + if (words[0] == "forcefield") { + forcefield = utils::strdup(words[1]); + } else if (words[0] == "bond-cubic") { + bond_cubic = utils::numeric(FLERR, words[1], false, lmp); + } else if (words[0] == "bond-quartic") { + bond_quartic = utils::numeric(FLERR, words[1], false, lmp); - copy = copy_next = nullptr; - words = words_next = nullptr; + } else if (words[0] == "angle-cubic") { + angle_cubic = utils::numeric(FLERR, words[1], false, lmp); + } else if (words[0] == "angle-quartic") { + angle_quartic = utils::numeric(FLERR, words[1], false, lmp); + } else if (words[0] == "angle-pentic") { + angle_pentic = utils::numeric(FLERR, words[1], false, lmp); + } else if (words[0] == "angle-sextic") { + angle_sextic = utils::numeric(FLERR, words[1], false, lmp); - while (true) { - if (nextflag) { - strcpy(line,next); - nextflag = 0; + } else if (words[0] == "opbendtype") { + if (words[1] == "allinger") { + opbendtype = ALLINGER; } else { - ptr = fgets(line,MAXLINE,fp); - if (!ptr) return -1; + error->all(FLERR, "Unrecognized opbendtype {} in {} PRM file", words[1], mystyle); } + } else if (words[0] == "opbend-cubic") { + opbend_cubic = utils::numeric(FLERR, words[1], false, lmp); + } else if (words[0] == "opbend-quartic") { + opbend_quartic = utils::numeric(FLERR, words[1], false, lmp); + } else if (words[0] == "opbend-pentic") { + opbend_pentic = utils::numeric(FLERR, words[1], false, lmp); + } else if (words[0] == "opbend-sextic") { + opbend_sextic = utils::numeric(FLERR, words[1], false, lmp); - if (strspn(line," \t\n\r") == strlen(line)) continue; - nwords = tokenize(line,words,copy); - if (strstr(words[0],"####")) { - delete[] words; - delete[] copy; - return 0; - } - if (strstr(words[0],"#") || strstr(words[0],"!!") || !isalpha(words[0][0])) { - delete[] words; - delete[] copy; - words = nullptr; - copy = nullptr; - continue; - } - while (true) { - ptr = fgets(next,MAXLINE,fp); - if (!ptr) { - nextflag = 0; - delete[] words; - delete[] copy; - return strlen(line); - } - nwords_next = tokenize(next,words_next,copy_next); - if (nwords_next == 0) break; - if (words_next[0][0] == '#') break; - if (isalpha(words_next[0][0])) break; - strcat(line,next); - delete[] words_next; - delete[] copy_next; - } - nextflag = 1; - break; - } + } else if (words[0] == "torsionunit") { + torsion_unit = utils::numeric(FLERR, words[1], false, lmp); - delete[] copy; - delete[] words; - delete[] copy_next; - delete[] words_next; + } else if (words[0] == "vdwtype") { + if (words[1] == "buffered-14-7") + vdwtype = BUFFERED_14_7; + else + error->all(FLERR, "Unrecognized vdwtype {} in {} PRM file", words[1], mystyle); + } else if (words[0] == "radiusrule") { + if (words[1] == "arithmetic") + radius_rule = ARITHMETIC; + else if (words[1] == "geometric") + radius_rule = GEOMETRIC; + else if (words[1] == "cubic-mean") + radius_rule = CUBIC_MEAN; + else + error->all(FLERR, "Unrecognized radiusrule {} in {} PRM file", words[1], mystyle); + } else if (words[0] == "radiustype") { + if (words[1] == "r-min") + radius_type = R_MIN; + else if (words[1] == "sigma") + radius_type = SIGMA; + else + error->all(FLERR, "Unrecognized radiustype {} in {} PRM file", words[1], mystyle); + } else if (words[0] == "radiussize") { + if (words[1] == "diameter") + radius_size = DIAMETER; + else + error->all(FLERR, "Unrecognized radiussize {} in {} PRM file", words[1], mystyle); + } else if (words[0] == "epsilonrule") { + if (words[1] == "arithmetic") + epsilon_rule = ARITHMETIC; + else if (words[1] == "geometric") + epsilon_rule = GEOMETRIC; + else if (words[1] == "harmonic") + epsilon_rule = HARMONIC; + else if (words[1] == "hhg") + epsilon_rule = HHG; + else if (words[1] == "w-h") + epsilon_rule = W_H; + else + error->all(FLERR, "Unrecognized epsilonrule {} in {} PRM file", words[1], mystyle); - int n = strlen(line); - return n; -} - -/* ---------------------------------------------------------------------- - tokenize str into white-space separated words - return nwords = number of words - return words = vector of ptrs to each word - also return copystr since words points into it - if a word is !!, that word and the rest of the line is discarded - IMPORTANT: caller must delete words and copystr -------------------------------------------------------------------------- */ - -int PairAmoeba::tokenize(char *str, char **&words, char *©str) -{ - int n = strlen(str) + 1; - copystr = new char[n]; - strcpy(copystr,str); - - int nword = count_words(copystr); - words = new char*[nword]; - - nword = 0; - char *word = strtok(copystr," \t\n\r\f"); - while (word) { - words[nword++] = word; - word = strtok(NULL," \t\n\r\f"); - if (word && strcmp(word,"!!") == 0) break; - } - - return nword; -} - -/* ---------------------------------------------------------------------- - count and return words in a single line - make copy of line before using strtok so as not to change line -------------------------------------------------------------------------- */ - -int PairAmoeba::count_words(const char *line) -{ - int n = strlen(line) + 1; - char *copy = new char[n]; - strcpy(copy,line); - - if (strtok(copy," \t\n\r\f") == NULL) { - delete[] copy; - return 0; - } - n = 1; - while (strtok(NULL," \t\n\r\f")) n++; - - delete[] copy; - return n; -} - -/* ---------------------------------------------------------------------- */ - -void PairAmoeba::file_ffield(int nwords, char **words) -{ - if (strcmp(words[0],"forcefield") == 0) { - int n = strlen(words[1]) + 1; - forcefield = new char[n]; - strcpy(forcefield,words[1]); - - } else if (strcmp(words[0],"bond-cubic") == 0) { - bond_cubic = utils::numeric(FLERR,words[1],true,lmp); - } else if (strcmp(words[0],"bond-quartic") == 0) { - bond_quartic = utils::numeric(FLERR,words[1],true,lmp); - - } else if (strcmp(words[0],"angle-cubic") == 0) { - angle_cubic = utils::numeric(FLERR,words[1],true,lmp); - } else if (strcmp(words[0],"angle-quartic") == 0) { - angle_quartic = utils::numeric(FLERR,words[1],true,lmp); - } else if (strcmp(words[0],"angle-pentic") == 0) { - angle_pentic = utils::numeric(FLERR,words[1],true,lmp); - } else if (strcmp(words[0],"angle-sextic") == 0) { - angle_sextic = utils::numeric(FLERR,words[1],true,lmp); - - } else if (strcmp(words[0],"opbendtype") == 0) { - if (strcmp(words[1],"allinger") == 0) opbendtype = ALLINGER; - else error->all(FLERR,"Unrecognized opbendtype in AMOEBA FF file"); - } else if (strcmp(words[0],"opbend-cubic") == 0) { - opbend_cubic = utils::numeric(FLERR,words[1],true,lmp); - } else if (strcmp(words[0],"opbend-quartic") == 0) { - opbend_quartic = utils::numeric(FLERR,words[1],true,lmp); - } else if (strcmp(words[0],"opbend-pentic") == 0) { - opbend_pentic = utils::numeric(FLERR,words[1],true,lmp); - } else if (strcmp(words[0],"opbend-sextic") == 0) { - opbend_sextic = utils::numeric(FLERR,words[1],true,lmp); - - } else if (strcmp(words[0],"torsionunit") == 0) { - torsion_unit = utils::numeric(FLERR,words[1],true,lmp); - - } else if (strcmp(words[0],"vdwtype") == 0) { - if (strcmp(words[1],"buffered-14-7") == 0) vdwtype = BUFFERED_14_7; - else error->all(FLERR,"Unrecognized vdwtype in AMOEBA FF file"); - } else if (strcmp(words[0],"radiusrule") == 0) { - if (strcmp(words[1],"arithmetic") == 0) radius_rule = ARITHMETIC; - else if (strcmp(words[1],"geometric") == 0) radius_rule = GEOMETRIC; - else if (strcmp(words[1],"cubic-mean") == 0) radius_rule = CUBIC_MEAN; - else error->all(FLERR,"Unrecognized radiusrule in AMOEBA FF file"); - } else if (strcmp(words[0],"radiustype") == 0) { - if (strcmp(words[1],"r-min") == 0) radius_type = R_MIN; - else if (strcmp(words[1],"sigma") == 0) radius_type = SIGMA; - else error->all(FLERR,"Unrecognized radiustype in AMOEBA FF file"); - } else if (strcmp(words[0],"radiussize") == 0) { - if (strcmp(words[1],"diameter") == 0) radius_size = DIAMETER; - else error->all(FLERR,"Unrecognized radiussize in AMOEBA FF file"); - } else if (strcmp(words[0],"epsilonrule") == 0) { - if (strcmp(words[1],"arithmetic") == 0) epsilon_rule = ARITHMETIC; - else if (strcmp(words[1],"geometric") == 0) epsilon_rule = GEOMETRIC; - else if (strcmp(words[1],"harmonic") == 0) epsilon_rule = HARMONIC; - else if (strcmp(words[1],"hhg") == 0) epsilon_rule = HHG; - else if (strcmp(words[1],"w-h") == 0) epsilon_rule = W_H; - else error->all(FLERR,"Unrecognized epsilonrule in AMOEBA FF file"); - - } else if (strcmp(words[0],"dielectric") == 0) { - am_dielectric = utils::numeric(FLERR,words[1],true,lmp); - } else if (strcmp(words[0],"polarization") == 0) { - if (strcmp(words[1],"mutual") == 0) poltyp = MUTUAL; - else if (strstr(words[1],"opt") == words[1]) { + } else if (words[0] == "dielectric") { + am_dielectric = utils::numeric(FLERR, words[1], false, lmp); + } else if (words[0] == "polarization") { + if (words[1] == "mutual") + poltyp = MUTUAL; + else if (utils::strmatch(words[1], "^opt")) { poltyp = OPT; - if (strcmp(words[1],"opt") == 0) optorder = 4; - else optorder = utils::inumeric(FLERR,&words[1][3],true,lmp); + if (words[1] == "opt") + optorder = 4; + else + optorder = utils::inumeric(FLERR, words[1].c_str() + 3, false, lmp); if (optorder < 1 || optorder > 6) - error->all(FLERR,"Unrecognized polarization OPTn in AMOEBA FF file"); - } else if (strcmp(words[1],"tcg") == 0) - error->all(FLERR,"Polarization TCG not yet supported in AMOEBA/HIPPO"); - else if (strcmp(words[1],"direct") == 0) poltyp = DIRECT; - else error->all(FLERR,"Unrecognized polarization in AMOEBA FF file"); + error->all(FLERR, "Unrecognized polarization {} in {} PRM file line {}", words[1], mystyle); + } else if (words[1] == "tcg") + error->all(FLERR, "Polarization TCG not yet supported in AMOEBA/HIPPO"); + else if (words[1] == "direct") + poltyp = DIRECT; + else + error->all(FLERR, "Unrecognized polarization {} in {} PRM file", words[1], mystyle); - } else if (strcmp(words[0],"vdw-12-scale") == 0) { - special_hal[1] = utils::numeric(FLERR,words[1],true,lmp); - } else if (strcmp(words[0],"vdw-13-scale") == 0) { - special_hal[2] = utils::numeric(FLERR,words[1],true,lmp); - } else if (strcmp(words[0],"vdw-14-scale") == 0) { - special_hal[3] = utils::numeric(FLERR,words[1],true,lmp); - } else if (strcmp(words[0],"vdw-15-scale") == 0) { - special_hal[4] = utils::numeric(FLERR,words[1],true,lmp); + } else if (words[0] == "vdw-12-scale") { + special_hal[1] = utils::numeric(FLERR, words[1], false, lmp); + } else if (words[0] == "vdw-13-scale") { + special_hal[2] = utils::numeric(FLERR, words[1], false, lmp); + } else if (words[0] == "vdw-14-scale") { + special_hal[3] = utils::numeric(FLERR, words[1], false, lmp); + } else if (words[0] == "vdw-15-scale") { + special_hal[4] = utils::numeric(FLERR, words[1], false, lmp); - } else if (strcmp(words[0],"rep-12-scale") == 0) { - special_repel[1] = utils::numeric(FLERR,words[1],true,lmp); - } else if (strcmp(words[0],"rep-13-scale") == 0) { - special_repel[2] = utils::numeric(FLERR,words[1],true,lmp); - } else if (strcmp(words[0],"rep-14-scale") == 0) { - special_repel[3] = utils::numeric(FLERR,words[1],true,lmp); - } else if (strcmp(words[0],"rep-15-scale") == 0) { - special_repel[4] = utils::numeric(FLERR,words[1],true,lmp); + } else if (words[0] == "rep-12-scale") { + special_repel[1] = utils::numeric(FLERR, words[1], false, lmp); + } else if (words[0] == "rep-13-scale") { + special_repel[2] = utils::numeric(FLERR, words[1], false, lmp); + } else if (words[0] == "rep-14-scale") { + special_repel[3] = utils::numeric(FLERR, words[1], false, lmp); + } else if (words[0] == "rep-15-scale") { + special_repel[4] = utils::numeric(FLERR, words[1], false, lmp); - } else if (strcmp(words[0],"disp-12-scale") == 0) { - special_disp[1] = utils::numeric(FLERR,words[1],true,lmp); - } else if (strcmp(words[0],"disp-13-scale") == 0) { - special_disp[2] = utils::numeric(FLERR,words[1],true,lmp); - } else if (strcmp(words[0],"disp-14-scale") == 0) { - special_disp[3] = utils::numeric(FLERR,words[1],true,lmp); - } else if (strcmp(words[0],"disp-15-scale") == 0) { - special_disp[4] = utils::numeric(FLERR,words[1],true,lmp); + } else if (words[0] == "disp-12-scale") { + special_disp[1] = utils::numeric(FLERR, words[1], false, lmp); + } else if (words[0] == "disp-13-scale") { + special_disp[2] = utils::numeric(FLERR, words[1], false, lmp); + } else if (words[0] == "disp-14-scale") { + special_disp[3] = utils::numeric(FLERR, words[1], false, lmp); + } else if (words[0] == "disp-15-scale") { + special_disp[4] = utils::numeric(FLERR, words[1], false, lmp); - } else if (strcmp(words[0],"mpole-12-scale") == 0) { - special_mpole[1] = utils::numeric(FLERR,words[1],true,lmp); - } else if (strcmp(words[0],"mpole-13-scale") == 0) { - special_mpole[2] = utils::numeric(FLERR,words[1],true,lmp); - } else if (strcmp(words[0],"mpole-14-scale") == 0) { - special_mpole[3] = utils::numeric(FLERR,words[1],true,lmp); - } else if (strcmp(words[0],"mpole-15-scale") == 0) { - special_mpole[4] = utils::numeric(FLERR,words[1],true,lmp); + } else if (words[0] == "mpole-12-scale") { + special_mpole[1] = utils::numeric(FLERR, words[1], false, lmp); + } else if (words[0] == "mpole-13-scale") { + special_mpole[2] = utils::numeric(FLERR, words[1], false, lmp); + } else if (words[0] == "mpole-14-scale") { + special_mpole[3] = utils::numeric(FLERR, words[1], false, lmp); + } else if (words[0] == "mpole-15-scale") { + special_mpole[4] = utils::numeric(FLERR, words[1], false, lmp); - } else if (strcmp(words[0],"polar-12-scale") == 0) { - special_polar_pscale[1] = utils::numeric(FLERR,words[1],true,lmp); - } else if (strcmp(words[0],"polar-13-scale") == 0) { - special_polar_pscale[2] = utils::numeric(FLERR,words[1],true,lmp); - } else if (strcmp(words[0],"polar-14-scale") == 0) { - special_polar_pscale[3] = utils::numeric(FLERR,words[1],true,lmp); - } else if (strcmp(words[0],"polar-15-scale") == 0) { - special_polar_pscale[4] = utils::numeric(FLERR,words[1],true,lmp); + } else if (words[0] == "polar-12-scale") { + special_polar_pscale[1] = utils::numeric(FLERR, words[1], false, lmp); + } else if (words[0] == "polar-13-scale") { + special_polar_pscale[2] = utils::numeric(FLERR, words[1], false, lmp); + } else if (words[0] == "polar-14-scale") { + special_polar_pscale[3] = utils::numeric(FLERR, words[1], false, lmp); + } else if (words[0] == "polar-15-scale") { + special_polar_pscale[4] = utils::numeric(FLERR, words[1], false, lmp); - } else if (strcmp(words[0],"polar-12-intra") == 0) { - special_polar_piscale[1] = utils::numeric(FLERR,words[1],true,lmp); - } else if (strcmp(words[0],"polar-13-intra") == 0) { - special_polar_piscale[2] = utils::numeric(FLERR,words[1],true,lmp); - } else if (strcmp(words[0],"polar-14-intra") == 0) { - special_polar_piscale[3] = utils::numeric(FLERR,words[1],true,lmp); - } else if (strcmp(words[0],"polar-15-intra") == 0) { - special_polar_piscale[4] = utils::numeric(FLERR,words[1],true,lmp); + } else if (words[0] == "polar-12-intra") { + special_polar_piscale[1] = utils::numeric(FLERR, words[1], false, lmp); + } else if (words[0] == "polar-13-intra") { + special_polar_piscale[2] = utils::numeric(FLERR, words[1], false, lmp); + } else if (words[0] == "polar-14-intra") { + special_polar_piscale[3] = utils::numeric(FLERR, words[1], false, lmp); + } else if (words[0] == "polar-15-intra") { + special_polar_piscale[4] = utils::numeric(FLERR, words[1], false, lmp); - } else if (strcmp(words[0],"induce-12-scale") == 0) { - special_polar_wscale[1] = utils::numeric(FLERR,words[1],true,lmp); - } else if (strcmp(words[0],"induce-13-scale") == 0) { - special_polar_wscale[2] = utils::numeric(FLERR,words[1],true,lmp); - } else if (strcmp(words[0],"induce-14-scale") == 0) { - special_polar_wscale[3] = utils::numeric(FLERR,words[1],true,lmp); - } else if (strcmp(words[0],"induce-15-scale") == 0) { - special_polar_wscale[4] = utils::numeric(FLERR,words[1],true,lmp); + } else if (words[0] == "induce-12-scale") { + special_polar_wscale[1] = utils::numeric(FLERR, words[1], false, lmp); + } else if (words[0] == "induce-13-scale") { + special_polar_wscale[2] = utils::numeric(FLERR, words[1], false, lmp); + } else if (words[0] == "induce-14-scale") { + special_polar_wscale[3] = utils::numeric(FLERR, words[1], false, lmp); + } else if (words[0] == "induce-15-scale") { + special_polar_wscale[4] = utils::numeric(FLERR, words[1], false, lmp); - } else if (strcmp(words[0],"direct-11-scale") == 0) { - polar_dscale = utils::numeric(FLERR,words[1],true,lmp); - } else if (strcmp(words[0],"direct-12-scale") == 0 || - strcmp(words[0],"direct-13-scale") == 0 || - strcmp(words[0],"direct-14-scale") == 0) { - double tmp = utils::numeric(FLERR,words[1],true,lmp); + } else if (words[0] == "direct-11-scale") { + polar_dscale = utils::numeric(FLERR, words[1], false, lmp); + } else if (utils::strmatch(words[0], "^direct-1[234]-scale$")) { + double tmp = utils::numeric(FLERR, words[1], false, lmp); if (tmp != 1.0) - error->all(FLERR,"AMOEBA FF file direct-scale 1-2, 1-3, 1-4 values should be 1.0"); - - } else if (strcmp(words[0],"mutual-11-scale") == 0) { - polar_uscale = utils::numeric(FLERR,words[1],true,lmp); - } else if (strcmp(words[0],"mutual-12-scale") == 0 || - strcmp(words[0],"mutual-13-scale") == 0 || - strcmp(words[0],"mutual-14-scale") == 0) { - double tmp = utils::numeric(FLERR,words[1],true,lmp); + error->all(FLERR, "{} FF direct-scale 1-2, 1-3, 1-4 values should be 1.0", + utils::uppercase(mystyle)); + } else if (words[0] == "mutual-11-scale") { + polar_uscale = utils::numeric(FLERR, words[1], false, lmp); + } else if (utils::strmatch(words[0], "^mutual-1[234]-scale$")) { + double tmp = utils::numeric(FLERR, words[1], false, lmp); if (tmp != 1.0) - error->all(FLERR,"AMOEBA FF file mutual-scale 1-2, 1-3, 1-4 values should be 1.0"); - - // error if LAMMPS does not recognize keyword - - } else error->all(FLERR, "LAMMPS does not recognize AMOEBA PRM file setting {}", words[0]); + error->all(FLERR, "{} FF mutual-scale 1-2, 1-3, 1-4 values should be 1.0", + utils::uppercase(mystyle)); + // error if LAMMPS does not recognize keyword + } else { + error->all(FLERR, "LAMMPS does not recognize {} PRM file setting on line {}: {}", + utils::uppercase(mystyle), nline, utils::join_words(words, " ")); + } } /* ---------------------------------------------------------------------- */ -void PairAmoeba::file_literature(int nwords, char **words) +void PairAmoeba::file_literature(const std::vector &words, int /*nline*/) { // do nothing, this section is skipped } /* ---------------------------------------------------------------------- */ -void PairAmoeba::file_atomtype(int nwords, char **words) +void PairAmoeba::file_atomtype(const std::vector &words, int nline) { - if (nwords < 8) - error->all(FLERR,"AMOEBA atom type line is invalid"); - if (strcmp(words[0],"atom") != 0) - error->all(FLERR,"AMOEBA atom type line is invalid"); + if (words[0] != "atom") + error->all(FLERR, "{} PRM file atom type line {} has invalid format: {}", + utils::uppercase(mystyle), nline, utils::join_words(words, " ")); - int itype = utils::inumeric(FLERR,words[1],true,lmp); - int iclass = utils::inumeric(FLERR,words[2],true,lmp); + if (words.size() < 8) + error->all(FLERR, "{} PRM file atom type line {} has too few values ({}): {}", + utils::uppercase(mystyle), nline, words.size(), utils::join_words(words, " ")); + + int itype = utils::inumeric(FLERR, words[1], false, lmp); + int iclass = utils::inumeric(FLERR, words[2], false, lmp); // grow per-type and per-class vecs/arrays as needed - allocate_type_class(itype,iclass); - - n_amtype = MAX(n_amtype,itype); - n_amclass = MAX(n_amclass,iclass); + allocate_type_class(itype, iclass); + n_amtype = MAX(n_amtype, itype); + n_amclass = MAX(n_amclass, iclass); // store words from line @@ -875,197 +879,237 @@ void PairAmoeba::file_atomtype(int nwords, char **words) amclass_defined[iclass] = 1; amtype2class[itype] = iclass; - atomic_num[itype] = utils::inumeric(FLERR,words[nwords-3],true,lmp); - am_mass[itype] = utils::numeric(FLERR,words[nwords-2],true,lmp); - valence[itype] = utils::inumeric(FLERR,words[nwords-1],true,lmp); + atomic_num[itype] = utils::inumeric(FLERR, words[words.size() - 3], false, lmp); + am_mass[itype] = utils::numeric(FLERR, words[words.size() - 2], false, lmp); + valence[itype] = utils::inumeric(FLERR, words[words.size() - 1], false, lmp); } /* ---------------------------------------------------------------------- */ -void PairAmoeba::file_vdwl(int nwords, char **words) +void PairAmoeba::file_vdwl(const std::vector &words, int nline) { - if (nwords != 4 && nwords != 5) - error->all(FLERR,"AMOEBA Van der Waals line is invalid"); - if (strcmp(words[0],"vdw") != 0) - error->all(FLERR,"AMOEBA Van der Waals line is invalid"); + if (words[0] != "vdw") + error->all(FLERR, "{} PRM file Van der Waals line {} has invalid format: {}", + utils::uppercase(mystyle), nline, utils::join_words(words, " ")); - int iclass = utils::inumeric(FLERR,words[1],true,lmp); + if (words.size() != 4 && words.size() != 5) + error->all(FLERR, "{} PRM file Vand der Walls line {} has incorrect length ({}): {}", + utils::uppercase(mystyle), nline, words.size(), utils::join_words(words, " ")); + + int iclass = utils::inumeric(FLERR, words[1], false, lmp); if (iclass < 1 || iclass > n_amclass) - error->all(FLERR,"AMOEBA Van der Waals type index is invalid"); + error->all(FLERR, "{} RPM file Van der Waals type index {} on line {} is invalid: {}", + utils::uppercase(mystyle), iclass, nline, utils::join_words(words, " ")); - vdwl_sigma[iclass] = utils::numeric(FLERR,words[2],true,lmp); - vdwl_eps[iclass] = utils::numeric(FLERR,words[3],true,lmp); - if (nwords == 4) kred[iclass] = 0.0; - else kred[iclass] = utils::numeric(FLERR,words[4],true,lmp); + vdwl_sigma[iclass] = utils::numeric(FLERR, words[2], false, lmp); + vdwl_eps[iclass] = utils::numeric(FLERR, words[3], false, lmp); + if (words.size() == 4) + kred[iclass] = 0.0; + else + kred[iclass] = utils::numeric(FLERR, words[4], false, lmp); } /* ---------------------------------------------------------------------- */ -void PairAmoeba::file_vdwl_pair(int nwords, char **words) +void PairAmoeba::file_vdwl_pair(const std::vector &words, int nline) { - if (nwords != 5) - error->all(FLERR,"AMOEBA Van der Waals pair line is invalid"); - if (strcmp(words[0],"vdwpr") != 0) - error->all(FLERR,"AMOEBA Van der Waals pair line is invalid"); + if (words[0] != "vdwpr") + error->all(FLERR, "{} PRM file Van der Waals pair line {} has invalid format: {}", + utils::uppercase(mystyle), nline, utils::join_words(words, " ")); + + if (words.size() != 5) + error->all(FLERR, "{} PRM file Van der Waals pair line {} has incorret length ({}): {}", + utils::uppercase(mystyle), nline, words.size(), utils::join_words(words, " ")); if (nvdwl_pair == max_vdwl_pair) { max_vdwl_pair += DELTA_VDWL_PAIR; - memory->grow(vdwl_class_pair,max_vdwl_pair,2,"amoeba:vdwl_class_pair"); - memory->grow(vdwl_sigma_pair,max_vdwl_pair,"amoeba:vdwl_sigma_pair"); - memory->grow(vdwl_eps_pair,max_vdwl_pair,"amoeba:vdwl_eps_pair"); + memory->grow(vdwl_class_pair, max_vdwl_pair, 2, "amoeba:vdwl_class_pair"); + memory->grow(vdwl_sigma_pair, max_vdwl_pair, "amoeba:vdwl_sigma_pair"); + memory->grow(vdwl_eps_pair, max_vdwl_pair, "amoeba:vdwl_eps_pair"); } - vdwl_class_pair[nvdwl_pair][0] = utils::inumeric(FLERR,words[1],true,lmp); - vdwl_class_pair[nvdwl_pair][1] = utils::inumeric(FLERR,words[2],true,lmp); - vdwl_sigma_pair[nvdwl_pair] = utils::numeric(FLERR,words[3],true,lmp); - vdwl_eps_pair[nvdwl_pair] = utils::numeric(FLERR,words[4],true,lmp); + vdwl_class_pair[nvdwl_pair][0] = utils::inumeric(FLERR, words[1], false, lmp); + vdwl_class_pair[nvdwl_pair][1] = utils::inumeric(FLERR, words[2], false, lmp); + vdwl_sigma_pair[nvdwl_pair] = utils::numeric(FLERR, words[3], false, lmp); + vdwl_eps_pair[nvdwl_pair] = utils::numeric(FLERR, words[4], false, lmp); nvdwl_pair++; } /* ---------------------------------------------------------------------- */ -void PairAmoeba::file_bstretch(int nwords, char **words) +void PairAmoeba::file_bstretch(const std::vector &words, int nline) { - if (nwords < 5) - error->all(FLERR,"AMOEBA bond stretch line is invalid"); - if (strcmp(words[0],"bond") != 0) - error->all(FLERR,"AMOEBA bond stretch line is invalid"); + if (words[0] != "bond") + error->all(FLERR, "{} PRM file bond stretch line {} has invalid format: {}", + utils::uppercase(mystyle), nline, utils::join_words(words, " ")); + + if (words.size() < 5) + error->all(FLERR, "{} PRM file bond stretch line {} has too few values ({}): {}", + utils::uppercase(mystyle), nline, words.size(), utils::join_words(words, " ")); } /* ---------------------------------------------------------------------- */ -void PairAmoeba::file_sbend(int nwords, char **words) +void PairAmoeba::file_sbend(const std::vector &words, int nline) { - if (nwords != 6) - error->all(FLERR,"AMOEBA strectch-bend line is invalid"); - if (strstr(words[0],"strbnd") != words[0]) - error->all(FLERR,"AMOEBA strectch-bend line is invalid"); + if (words[0] != "strbnd") + error->all(FLERR, "{} PRM file stretch-bend line {} has invalid format: {}", + utils::uppercase(mystyle), nline, utils::join_words(words, " ")); + + if (words.size() != 6) + error->all(FLERR, "{} PRM file stretch-bend line {} has too few values ({}): {}", + utils::uppercase(mystyle), nline, words.size(), utils::join_words(words, " ")); } /* ---------------------------------------------------------------------- */ -void PairAmoeba::file_abend(int nwords, char **words) +void PairAmoeba::file_abend(const std::vector &words, int nline) { - if (nwords < 6) - error->all(FLERR,"AMOEBA angle bending line is invalid"); + if (words.size() < 6) + error->all(FLERR, "{} PRM file angle bending line {} has too few values ({}): {}", + utils::uppercase(mystyle), nline, words.size(), utils::join_words(words, " ")); } /* ---------------------------------------------------------------------- */ -void PairAmoeba::file_pauli(int nwords, char **words) +void PairAmoeba::file_pauli(const std::vector &words, int nline) { - if (nwords < 5) - error->all(FLERR,"AMOEBA Pauli repulsion line is invalid"); - if (strstr(words[0],"repulsion") != words[0]) - error->all(FLERR,"AMOEBA Pauli repulsion line is invalid"); + if (words[0] != "repulsion") + error->all(FLERR, "{} PRM file Pauli repulsion line {} has invalid format: {}", + utils::uppercase(mystyle), nline, utils::join_words(words, " ")); - int itype = utils::inumeric(FLERR,words[1],true,lmp); + if (words.size() < 5) + error->all(FLERR, "{} PRM file Pauli repulsion line {} has too few values ({}): {}", + utils::uppercase(mystyle), nline, words.size(), utils::join_words(words, " ")); + + int itype = utils::inumeric(FLERR, words[1], false, lmp); if (itype < 1 || itype > n_amtype) - error->all(FLERR,"AMOEBA Pauli repulsion type index is invalid"); + error->all(FLERR, "{} PRM file Pauli repulsion type index {} on line {} is invalid: {}", + utils::uppercase(mystyle), itype, nline, utils::join_words(words, " ")); // negate the elepr setting - sizpr[itype] = utils::numeric(FLERR,words[2],true,lmp); - dmppr[itype] = utils::numeric(FLERR,words[3],true,lmp); - elepr[itype] = - fabs(utils::numeric(FLERR,words[4],true,lmp)); + sizpr[itype] = utils::numeric(FLERR, words[2], false, lmp); + dmppr[itype] = utils::numeric(FLERR, words[3], false, lmp); + elepr[itype] = -fabs(utils::numeric(FLERR, words[4], false, lmp)); } /* ---------------------------------------------------------------------- */ -void PairAmoeba::file_dispersion(int nwords, char **words) +void PairAmoeba::file_dispersion(const std::vector &words, int nline) { - if (nwords < 4) - error->all(FLERR,"AMOEBA dispersion line is invalid"); - if (strstr(words[0],"dispersion") != words[0]) - error->all(FLERR,"AMOEBA dipersion line is invalid"); + if (words[0] != "dispersion") + error->all(FLERR, "{} PRM file dispersion line {} has invalid format: {}", + utils::uppercase(mystyle), nline, utils::join_words(words, " ")); - int iclass = utils::inumeric(FLERR,words[1],true,lmp); + if (words.size() < 4) + error->all(FLERR, "{} PRM file dispersion line {} has too few values ({}): {}", + utils::uppercase(mystyle), nline, words.size(), utils::join_words(words, " ")); + + int iclass = utils::inumeric(FLERR, words[1], false, lmp); if (iclass < 1 || iclass > n_amclass) - error->all(FLERR,"AMOEBA dispersion class index is invalid"); + error->all(FLERR, "{} PRM file dispersion class index {} on line {} is invalid: {}", + utils::uppercase(mystyle), iclass, nline, utils::join_words(words, " ")); - csix[iclass] = utils::numeric(FLERR,words[2],true,lmp); - adisp[iclass] = utils::numeric(FLERR,words[3],true,lmp); + csix[iclass] = utils::numeric(FLERR, words[2], false, lmp); + adisp[iclass] = utils::numeric(FLERR, words[3], false, lmp); } /* ---------------------------------------------------------------------- */ -void PairAmoeba::file_ub(int nwords, char **words) +void PairAmoeba::file_ub(const std::vector &words, int nline) { - if (nwords != 6) - error->all(FLERR,"AMOEBA Urey-Bradley line is invalid"); - if (strstr(words[0],"ureybrad") != words[0]) - error->all(FLERR,"AMOEBA Urey-Bradley line is invalid"); + if (words[0] != "ureybrad") + error->all(FLERR, "{} PRM file Urey-Bradley line {} has invalid format: {}", + utils::uppercase(mystyle), nline, utils::join_words(words, " ")); + + if (words.size() != 6) + error->all(FLERR, "{} PRM file Urey-Bradley line {} has incorrect length ({}): {}", + utils::uppercase(mystyle), nline, words.size(), utils::join_words(words, " ")); } /* ---------------------------------------------------------------------- */ -void PairAmoeba::file_outplane(int nwords, char **words) +void PairAmoeba::file_outplane(const std::vector &words, int nline) { - if (nwords != 6) - error->all(FLERR,"AMOEBA out-of-plane bend line is invalid"); - if (strstr(words[0],"opbend") != words[0]) - error->all(FLERR,"AMOEBA out-of-plane bend line is invalid"); + if (words[0] != "opbend") + error->all(FLERR, "{} PRM file out-of-plane bend line {} has invalid format: {}", + utils::uppercase(mystyle), nline, utils::join_words(words, " ")); + + if (words.size() != 6) + error->all(FLERR, "{} PRM file out-of-plane bend line {} has incorrect length ({}): {}", + utils::uppercase(mystyle), nline, words.size(), utils::join_words(words, " ")); } /* ---------------------------------------------------------------------- */ -void PairAmoeba::file_torsion(int nwords, char **words) +void PairAmoeba::file_torsion(const std::vector &words, int nline) { - if (nwords != 14) - error->all(FLERR,"AMOEBA torsional line is invalid"); - if (strstr(words[0],"torsion") != words[0]) - error->all(FLERR,"AMOEBA torsional line is invalid"); + if (words[0] != "torsion") + error->all(FLERR, "{} PRM file torsion line {} has invalid format: {}", + utils::uppercase(mystyle), nline, utils::join_words(words, " ")); + + if (words.size() != 14) + error->all(FLERR, "{} PRM file torsion line {} has incorrect length ({}): {}", + utils::uppercase(mystyle), nline, words.size(), utils::join_words(words, " ")); } /* ---------------------------------------------------------------------- */ -void PairAmoeba::file_pitorsion(int nwords, char **words) +void PairAmoeba::file_pitorsion(const std::vector &words, int nline) { - if (nwords != 4) - error->all(FLERR,"AMOEBA pi-torsion line is invalid"); - if (strstr(words[0],"pitors") != words[0]) - error->all(FLERR,"AMOEBA pi-torsion line is invalid"); + if (words[0] != "pitors") + error->all(FLERR, "{} PRM file pi-torsion line {} has invalid format: {}", + utils::uppercase(mystyle), nline, utils::join_words(words, " ")); + + if (words.size() != 4) + error->all(FLERR, "{} PRM file pi-torsion line {} has incorrect length ({}): {}", + utils::uppercase(mystyle), nline, words.size(), utils::join_words(words, " ")); } /* ---------------------------------------------------------------------- */ -void PairAmoeba::file_multipole(int nwords, char **words) +void PairAmoeba::file_multipole(const std::vector &words, int nline) { - if (nwords < 12 || nwords > 15) - error->all(FLERR,"AMOEBA atomic multipole line is invalid"); - if (strstr(words[0],"multipole") != words[0]) - error->all(FLERR,"AMOEBA atomic multipole line is invalid"); + if (words[0] != "multipole") + error->all(FLERR, "{} PRM file atomic multipole line {} has invalid format: {}", + utils::uppercase(mystyle), nline, utils::join_words(words, " ")); - int itype = utils::inumeric(FLERR,words[1],true,lmp); + if (words.size() < 12 || words.size() > 15) + error->all(FLERR, "{} PRM file atomic multipole line {} has incorrect length ({}): {}", + utils::uppercase(mystyle), nline, words.size(), utils::join_words(words, " ")); + + int itype = utils::inumeric(FLERR, words[1], false, lmp); if (itype < 1 || itype > n_amtype) - error->all(FLERR,"AMOEBA atomic multipole type index is invalid"); + error->all(FLERR, "{} PRM file atomic multipole type index {} on line {} is invalid: {}", + utils::uppercase(mystyle), itype, nline, utils::join_words(words, " ")); int iframe = nmultiframe[itype]; - if (iframe == MAX_FRAME_PER_TYPE) - error->all(FLERR,"AMOEBA MAX_FRAME_PER_TYPE is too small"); + if (iframe >= MAX_FRAME_PER_TYPE) + error->all(FLERR, "{} MAX_FRAME_PER_TYPE is too small: {}", utils::uppercase(mystyle), iframe); int extra; - if (nwords == 12) { + if (words.size() == 12) { zpole[itype][iframe] = xpole[itype][iframe] = ypole[itype][iframe] = 0; extra = 2; - } else if (nwords == 13) { - zpole[itype][iframe] = utils::inumeric(FLERR,words[2],true,lmp); + } else if (words.size() == 13) { + zpole[itype][iframe] = utils::inumeric(FLERR, words[2], false, lmp); xpole[itype][iframe] = ypole[itype][iframe] = 0; extra = 3; - } else if (nwords == 14) { - zpole[itype][iframe] = utils::inumeric(FLERR,words[2],true,lmp); - xpole[itype][iframe] = utils::inumeric(FLERR,words[3],true,lmp); + } else if (words.size() == 14) { + zpole[itype][iframe] = utils::inumeric(FLERR, words[2], false, lmp); + xpole[itype][iframe] = utils::inumeric(FLERR, words[3], false, lmp); ypole[itype][iframe] = 0; extra = 4; - } else if (nwords == 15) { - zpole[itype][iframe] = utils::inumeric(FLERR,words[2],true,lmp); - xpole[itype][iframe] = utils::inumeric(FLERR,words[3],true,lmp); - ypole[itype][iframe] = utils::inumeric(FLERR,words[4],true,lmp); + } else if (words.size() == 15) { + zpole[itype][iframe] = utils::inumeric(FLERR, words[2], false, lmp); + xpole[itype][iframe] = utils::inumeric(FLERR, words[3], false, lmp); + ypole[itype][iframe] = utils::inumeric(FLERR, words[4], false, lmp); extra = 5; } for (int i = 0; i < 10; i++) - fpole[itype][iframe][i] = utils::numeric(FLERR,words[extra+i],true,lmp); + fpole[itype][iframe][i] = utils::numeric(FLERR, words[extra + i], false, lmp); // convert fpole to be 13 values by symmetrizing quadrupole 3x3 matrix // xx yx yy zx zy zz --> xx xy xz yz yy yz zx zy zz @@ -1088,10 +1132,8 @@ void PairAmoeba::file_multipole(int nwords, char **words) // convert the dipole and quadrupole moments to Angstroms // quadrupole terms divided by 3 for use as traceless values - for (int i = 1; i < 4; i++) - fpole[itype][iframe][i] *= BOHR; - for (int i = 4; i < 13; i++) - fpole[itype][iframe][i] *= BOHR*BOHR / 3.0; + for (int i = 1; i < 4; i++) fpole[itype][iframe][i] *= BOHR; + for (int i = 4; i < 13; i++) fpole[itype][iframe][i] *= BOHR * BOHR / 3.0; // set mpaxis from xyz pole values // uses both positive and negative values @@ -1120,71 +1162,80 @@ void PairAmoeba::file_multipole(int nwords, char **words) /* ---------------------------------------------------------------------- */ -void PairAmoeba::file_charge_penetration(int nwords, char **words) +void PairAmoeba::file_charge_penetration(const std::vector &words, int nline) { - if (nwords < 4) - error->all(FLERR,"AMOEBA charge penetration line is invalid"); - if (strstr(words[0],"chgpen") != words[0]) - error->all(FLERR,"AMOEBA charge penetration line is invalid"); + if (words[0] != "chgpen") + error->all(FLERR, "{} PRM file charge penetration line {} has invalid format: {}", + utils::uppercase(mystyle), nline, utils::join_words(words, " ")); - int iclass = utils::inumeric(FLERR,words[1],true,lmp); + if (words.size() < 4) + error->all(FLERR, "{} PRM file charge penetration line {} has too few values ({}): {}", + utils::uppercase(mystyle), nline, words.size(), utils::join_words(words, " ")); + + int iclass = utils::inumeric(FLERR, words[1], false, lmp); if (iclass < 1 || iclass > n_amclass) - error->all(FLERR,"AMOEBA charge penetration class index is invalid"); + error->all(FLERR, "{} PRM file charge penetration class index {} on line {} is invalid: {}", + utils::uppercase(mystyle), iclass, nline, utils::join_words(words, " ")); - pcore[iclass] = fabs(utils::numeric(FLERR,words[2],true,lmp)); - palpha[iclass] = utils::numeric(FLERR,words[3],true,lmp); + pcore[iclass] = fabs(utils::numeric(FLERR, words[2], false, lmp)); + palpha[iclass] = utils::numeric(FLERR, words[3], false, lmp); } /* ---------------------------------------------------------------------- */ -void PairAmoeba::file_dippolar(int nwords, char **words) +void PairAmoeba::file_dippolar(const std::vector &words, int nline) { - int nparams; - if (amoeba) nparams = 4; - else nparams = 3; + const int ndipparams = amoeba ? 4 : 3; + if (words[0] != "polarize") + error->all(FLERR, "{} PRM file dipole polariability line {} has invalid format: {}", + utils::uppercase(mystyle), nline, utils::join_words(words, " ")); - if (nwords < nparams) - error->all(FLERR,"AMOEBA dipole polarizability line is invalid"); - if (strstr(words[0],"polarize") != words[0]) - error->all(FLERR,"AMOEBA dipole polarizability line is invalid"); + if (words.size() < ndipparams) + error->all(FLERR, "{} PRM file dipole polarizability line {} has too few values ({}): {}", + utils::uppercase(mystyle), nline, words.size(), utils::join_words(words, " ")); - int itype = utils::inumeric(FLERR,words[1],true,lmp); + int itype = utils::inumeric(FLERR, words[1], false, lmp); if (itype < 1 || itype > n_amtype) - error->all(FLERR,"AMOEBA dipole polarizabilty type index is invalid"); + error->all(FLERR, "{} PRM file dipole polarizability type index {} on line {} is invalid: {}", + utils::uppercase(mystyle), itype, nline, utils::join_words(words, " ")); - polarity[itype] = utils::numeric(FLERR,words[2],true,lmp); - pdamp[itype] = pow(polarity[itype],1.0/6.0); - if (amoeba) thole[itype] = utils::numeric(FLERR,words[3],true,lmp); + polarity[itype] = utils::numeric(FLERR, words[2], false, lmp); + pdamp[itype] = pow(polarity[itype], 1.0 / 6.0); + if (amoeba) thole[itype] = utils::numeric(FLERR, words[3], false, lmp); // eventually AMOEBA+ files will set dirdamp dirdamp[itype] = 0.0; - int ngroup = nwords - nparams; + int ngroup = words.size() - ndipparams; if (ngroup > MAX_TYPE_PER_GROUP) - error->all(FLERR,"AMOEBA MAX_TYPE_PER_GROUP is too small"); + error->all(FLERR, "{} MAX_TYPE_PER_GROUP is too small: {} vs {}", utils::uppercase(mystyle), + MAX_TYPE_PER_GROUP, ngroup); npolgroup[itype] = ngroup; for (int igroup = 0; igroup < ngroup; igroup++) - polgroup[itype][igroup] = - utils::inumeric(FLERR,words[nparams+igroup],true,lmp); + polgroup[itype][igroup] = utils::inumeric(FLERR, words[ndipparams + igroup], false, lmp); } /* ---------------------------------------------------------------------- */ -void PairAmoeba::file_charge_transfer(int nwords, char **words) +void PairAmoeba::file_charge_transfer(const std::vector &words, int nline) { - if (nwords < 4) - error->all(FLERR,"AMOEBA charge transfer line is invalid"); - if (strstr(words[0],"chgtrn") != words[0]) - error->all(FLERR,"AMOEBA charge transfer line is invalid"); + if (words[0] != "chgtrn") + error->all(FLERR, "{} PRM file charge transfer line {} has invalid format: {}", + utils::uppercase(mystyle), nline, utils::join_words(words, " ")); - int iclass = utils::inumeric(FLERR,words[1],true,lmp); + if (words.size() < 4) + error->all(FLERR, "{} PRM file charge transfer line {} has too few values ({}): {}", + utils::uppercase(mystyle), nline, words.size(), utils::join_words(words, " ")); + + int iclass = utils::inumeric(FLERR, words[1], false, lmp); if (iclass < 1 || iclass > n_amclass) - error->all(FLERR,"AMOEBA charge transfer class index is invalid"); + error->all(FLERR, "{} PRM file charge transfer class index {} on line {} is invalid: {}", + utils::uppercase(mystyle), iclass, nline, utils::join_words(words, " ")); - chgct[iclass] = utils::numeric(FLERR,words[2],true,lmp); - dmpct[iclass] = utils::numeric(FLERR,words[3],true,lmp); + chgct[iclass] = utils::numeric(FLERR, words[2], false, lmp); + dmpct[iclass] = utils::numeric(FLERR, words[3], false, lmp); } /* ---------------------------------------------------------------------- diff --git a/src/AMOEBA/pair_amoeba.h b/src/AMOEBA/pair_amoeba.h index 2fa211fbfc..7b0719bca0 100644 --- a/src/AMOEBA/pair_amoeba.h +++ b/src/AMOEBA/pair_amoeba.h @@ -448,32 +448,28 @@ class PairAmoeba : public Pair { void read_prmfile(char *); void read_keyfile(char *); - int read_section_line(FILE *fp, char *, int &, char *); - int tokenize(char *, char **&, char *&); - int count_words(const char *); - void initialize_type_class(); void allocate_type_class(int, int); void deallocate_type_class(); - void file_ffield(int, char **); - void file_literature(int, char **); - void file_atomtype(int, char **); - void file_vdwl(int, char **); - void file_vdwl_pair(int, char **); - void file_bstretch(int, char **); - void file_sbend(int, char **); - void file_abend(int, char **); - void file_pauli(int, char **); - void file_dispersion(int, char **); - void file_ub(int, char **); - void file_outplane(int, char **); - void file_torsion(int, char **); - void file_pitorsion(int, char **); - void file_multipole(int, char **); - void file_charge_penetration(int, char **); - void file_dippolar(int, char **); - void file_charge_transfer(int, char **); + void file_ffield(const std::vector &, int); + void file_literature(const std::vector &, int); + void file_atomtype(const std::vector &, int); + void file_vdwl(const std::vector &, int); + void file_vdwl_pair(const std::vector &, int); + void file_bstretch(const std::vector &, int); + void file_sbend(const std::vector &, int); + void file_abend(const std::vector &, int); + void file_pauli(const std::vector &, int); + void file_dispersion(const std::vector &, int); + void file_ub(const std::vector &, int); + void file_outplane(const std::vector &, int); + void file_torsion(const std::vector &, int); + void file_pitorsion(const std::vector &, int); + void file_multipole(const std::vector &, int); + void file_charge_penetration(const std::vector &, int); + void file_dippolar(const std::vector &, int); + void file_charge_transfer(const std::vector &, int); // inline function for neighbor list unmasking From f1b14fa4a28c5a00542030a14e68cd6929db3c68 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 5 Jul 2022 00:16:31 -0400 Subject: [PATCH 528/585] improve formatting --- src/AMOEBA/pair_amoeba.cpp | 18 +++++++++--------- 1 file changed, 9 insertions(+), 9 deletions(-) diff --git a/src/AMOEBA/pair_amoeba.cpp b/src/AMOEBA/pair_amoeba.cpp index 08dbb4adc1..4dd8ba16be 100644 --- a/src/AMOEBA/pair_amoeba.cpp +++ b/src/AMOEBA/pair_amoeba.cpp @@ -517,19 +517,19 @@ void PairAmoeba::finish() if (comm->me == 0) { utils::logmesg(lmp,"\n{} timing breakdown:\n", utils::uppercase(mystyle)); - utils::logmesg(lmp," Init time: {:.6g} {:.3g}%\n", time_init, time_init/time_total); + utils::logmesg(lmp," Init time: {:<12.6g} {:6.2f}%\n", time_init, time_init/time_total); if (amoeba) { - utils::logmesg(lmp," Hal time: {:.6g} {:.3g}%\n", time_hal, time_hal/time_total); + utils::logmesg(lmp," Hal time: {:<12.6g} {:6.2f}%\n", time_hal, time_hal/time_total); } else { // hippo - utils::logmesg(lmp," Repulse time: {:.6g} {:.3g}%\n", time_repulse, time_repulse/time_total); - utils::logmesg(lmp," Disp time: {:.6g} {:.3g}%\n", time_disp, time_disp/time_total); + utils::logmesg(lmp," Repulse time: {:<12.6g} {:6.2f}%\n", time_repulse, time_repulse/time_total); + utils::logmesg(lmp," Disp time: {:<12.6g} {:6.2f}%\n", time_disp, time_disp/time_total); } - utils::logmesg(lmp," Mpole time: {:.6g} {:.3g}%\n", time_mpole, time_mpole/time_total); - utils::logmesg(lmp," Induce time: {:.6g} {:.3g}%\n", time_induce, time_induce/time_total); - utils::logmesg(lmp," Polar time: {:.6g} {:.3g}%\n", time_polar, time_polar/time_total); + utils::logmesg(lmp," Mpole time: {:<12.6g} {:6.2f}%\n", time_mpole, time_mpole/time_total); + utils::logmesg(lmp," Induce time: {:<12.6g} {:6.2f}%\n", time_induce, time_induce/time_total); + utils::logmesg(lmp," Polar time: {:<12.6g} {:6.2f}%\n", time_polar, time_polar/time_total); if (!amoeba) - utils::logmesg(lmp," Qxfer time: {:.6g} {:.6g}\n", time_qxfer, time_qxfer/time_total); - utils::logmesg(lmp," Total time: {:.6g}\n",time_total * 100.0); + utils::logmesg(lmp," Qxfer time: {:<12.6g} {:6.2f}%\n", time_qxfer, time_qxfer/time_total); + utils::logmesg(lmp," Total time: {:<12.6g}\n",time_total * 100.0); } } From 574818c3e9951d647b373d8572d3a80b53423023 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 5 Jul 2022 00:27:28 -0400 Subject: [PATCH 529/585] add unit test for utils::join_words() --- unittest/utils/test_utils.cpp | 18 ++++++++++++++++++ 1 file changed, 18 insertions(+) diff --git a/unittest/utils/test_utils.cpp b/unittest/utils/test_utils.cpp index fac9767f62..decd7d6379 100644 --- a/unittest/utils/test_utils.cpp +++ b/unittest/utils/test_utils.cpp @@ -139,6 +139,24 @@ TEST(Utils, count_words_with_extra_spaces) ASSERT_EQ(utils::count_words(" some text # comment "), 4); } +TEST(Utils, join_words) +{ + std::vector words = {"one", "two", "three" }; + auto combined = utils::join_words(words, " "); + ASSERT_THAT(combined, StrEq("one two three")); + combined = utils::join_words(words, ""); + ASSERT_THAT(combined, StrEq("onetwothree")); + words[1] = "two "; + combined = utils::join_words(words, "__"); + ASSERT_THAT(combined, StrEq("one__two __three")); + words.resize(1); + combined = utils::join_words(words, "/"); + ASSERT_THAT(combined, StrEq("one")); + words.push_back(""); + combined = utils::join_words(words, "1"); + ASSERT_THAT(combined, StrEq("one1")); +} + TEST(Utils, split_words_simple) { auto list = utils::split_words("one two three"); From f58d413fbd0162c5d99e8f64f7dd2b86fd1713e2 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 5 Jul 2022 06:59:31 -0400 Subject: [PATCH 530/585] Update test examples and script to be more in line with other LAMMPS examples --- examples/amoeba/Compare.sh | 52 - examples/amoeba/Test.sh | 68 +- examples/amoeba/dump.water_box.amoeba.1 | 7227 ----------------- examples/amoeba/dump.water_box.amoeba.32 | 7227 ----------------- examples/amoeba/dump.water_box.hippo.1 | 7227 ----------------- examples/amoeba/dump.water_box.hippo.32 | 7227 ----------------- examples/amoeba/dump.water_dimer.amoeba.1 | 165 - examples/amoeba/dump.water_dimer.amoeba.4 | 165 - examples/amoeba/dump.water_dimer.hippo.1 | 165 - examples/amoeba/dump.water_dimer.hippo.4 | 165 - examples/amoeba/dump.water_hexamer.amoeba.1 | 297 - examples/amoeba/dump.water_hexamer.amoeba.4 | 297 - examples/amoeba/dump.water_hexamer.hippo.1 | 297 - examples/amoeba/dump.water_hexamer.hippo.4 | 297 - examples/amoeba/in.ubiquitin | 4 +- examples/amoeba/in.water_box.amoeba | 4 +- examples/amoeba/in.water_box.hippo | 4 +- examples/amoeba/in.water_dimer.amoeba | 4 +- examples/amoeba/in.water_dimer.hippo | 4 +- examples/amoeba/in.water_hexamer.amoeba | 4 +- examples/amoeba/in.water_hexamer.hippo | 4 +- examples/amoeba/log.5Jul22.ubiquitin.g++.1 | 162 + examples/amoeba/log.5Jul22.ubiquitin.g++.4 | 162 + .../amoeba/log.5Jul22.water_box.amoeba.g++.1 | 150 + .../amoeba/log.5Jul22.water_box.amoeba.g++.4 | 150 + .../amoeba/log.5Jul22.water_box.hippo.g++.1 | 149 + .../amoeba/log.5Jul22.water_box.hippo.g++.4 | 149 + ....1 => log.5Jul22.water_dimer.amoeba.g++.1} | 71 +- ....4 => log.5Jul22.water_dimer.amoeba.g++.4} | 71 +- ...o.1 => log.5Jul22.water_dimer.hippo.g++.1} | 75 +- ...o.4 => log.5Jul22.water_dimer.hippo.g++.4} | 77 +- ... => log.5Jul22.water_hexamer.amoeba.g++.1} | 69 +- ... => log.5Jul22.water_hexamer.amoeba.g++.4} | 71 +- ...1 => log.5Jul22.water_hexamer.hippo.g++.1} | 73 +- ...4 => log.5Jul22.water_hexamer.hippo.g++.4} | 75 +- 35 files changed, 1233 insertions(+), 31175 deletions(-) delete mode 100644 examples/amoeba/Compare.sh mode change 100644 => 100755 examples/amoeba/Test.sh delete mode 100644 examples/amoeba/dump.water_box.amoeba.1 delete mode 100644 examples/amoeba/dump.water_box.amoeba.32 delete mode 100644 examples/amoeba/dump.water_box.hippo.1 delete mode 100644 examples/amoeba/dump.water_box.hippo.32 delete mode 100644 examples/amoeba/dump.water_dimer.amoeba.1 delete mode 100644 examples/amoeba/dump.water_dimer.amoeba.4 delete mode 100644 examples/amoeba/dump.water_dimer.hippo.1 delete mode 100644 examples/amoeba/dump.water_dimer.hippo.4 delete mode 100644 examples/amoeba/dump.water_hexamer.amoeba.1 delete mode 100644 examples/amoeba/dump.water_hexamer.amoeba.4 delete mode 100644 examples/amoeba/dump.water_hexamer.hippo.1 delete mode 100644 examples/amoeba/dump.water_hexamer.hippo.4 create mode 100644 examples/amoeba/log.5Jul22.ubiquitin.g++.1 create mode 100644 examples/amoeba/log.5Jul22.ubiquitin.g++.4 create mode 100644 examples/amoeba/log.5Jul22.water_box.amoeba.g++.1 create mode 100644 examples/amoeba/log.5Jul22.water_box.amoeba.g++.4 create mode 100644 examples/amoeba/log.5Jul22.water_box.hippo.g++.1 create mode 100644 examples/amoeba/log.5Jul22.water_box.hippo.g++.4 rename examples/amoeba/{log.water_dimer.amoeba.1 => log.5Jul22.water_dimer.amoeba.g++.1} (50%) rename examples/amoeba/{log.water_dimer.amoeba.4 => log.5Jul22.water_dimer.amoeba.g++.4} (50%) rename examples/amoeba/{log.water_dimer.hippo.1 => log.5Jul22.water_dimer.hippo.g++.1} (50%) rename examples/amoeba/{log.water_dimer.hippo.4 => log.5Jul22.water_dimer.hippo.g++.4} (51%) rename examples/amoeba/{log.water_hexamer.amoeba.1 => log.5Jul22.water_hexamer.amoeba.g++.1} (50%) rename examples/amoeba/{log.water_hexamer.amoeba.4 => log.5Jul22.water_hexamer.amoeba.g++.4} (50%) rename examples/amoeba/{log.water_hexamer.hippo.1 => log.5Jul22.water_hexamer.hippo.g++.1} (51%) rename examples/amoeba/{log.water_hexamer.hippo.4 => log.5Jul22.water_hexamer.hippo.g++.4} (50%) diff --git a/examples/amoeba/Compare.sh b/examples/amoeba/Compare.sh deleted file mode 100644 index fbe05275e0..0000000000 --- a/examples/amoeba/Compare.sh +++ /dev/null @@ -1,52 +0,0 @@ -# compare test runs to original runs - -# dimer - -kdiff.py log.water_dimer.amoeba.1 log.water_dimer.amoeba.1.test -kdiff.py dump.water_dimer.amoeba.1 dump.water_dimer.amoeba.1.test - -kdiff.py log.water_dimer.amoeba.4 log.water_dimer.amoeba.4.test -kdiff.py dump.water_dimer.amoeba.4 dump.water_dimer.amoeba.4.test - -kdiff.py log.water_dimer.hippo.1 log.water_dimer.hippo.1.test -kdiff.py dump.water_dimer.hippo.1 dump.water_dimer.hippo.1.test - -kdiff.py log.water_dimer.hippo.4 log.water_dimer.hippo.4.test -kdiff.py dump.water_dimer.hippo.4 dump.water_dimer.hippo.4.test - -# hexamer - -kdiff.py log.water_hexamer.amoeba.1 log.water_hexamer.amoeba.1.test -kdiff.py dump.water_hexamer.amoeba.1 dump.water_hexamer.amoeba.1.test - -kdiff.py log.water_hexamer.amoeba.4 log.water_hexamer.amoeba.4.test -kdiff.py dump.water_hexamer.amoeba.4 dump.water_hexamer.amoeba.4.test - -kdiff.py log.water_hexamer.hippo.1 log.water_hexamer.hippo.1.test -kdiff.py dump.water_hexamer.hippo.1 dump.water_hexamer.hippo.1.test - -kdiff.py log.water_hexamer.hippo.4 log.water_hexamer.hippo.4.test -kdiff.py dump.water_hexamer.hippo.4 dump.water_hexamer.hippo.4.test - -# water box - -kdiff.py log.water_box.amoeba.1 log.water_box.amoeba.1.test -kdiff.py dump.water_box.amoeba.1 dump.water_box.amoeba.1.test - -kdiff.py log.water_box.amoeba.32 log.water_box.amoeba.32.test -kdiff.py dump.water_box.amoeba.32 dump.water_box.amoeba.32.test - -kdiff.py log.water_box.hippo.1 log.water_box.hippo.1.test -kdiff.py dump.water_box.hippo.1 dump.water_box.hippo.1.test - -kdiff.py log.water_box.hippo.32 log.water_box.hippo.32.test -kdiff.py dump.water_box.hippo.32 dump.water_box.hippo.32.test - -# ubiquitin - -kdiff.py log.ubiquitin.1 log.ubiquitin.1.test -kdiff.py dump.ubiquitin.1 dump.ubiquitin.1.test - -kdiff.py log.ubiquitin.32 log.ubiquitin.32.test -kdiff.py dump.ubiquitin.32 dump.ubiquitin.32.test - diff --git a/examples/amoeba/Test.sh b/examples/amoeba/Test.sh old mode 100644 new mode 100755 index a76e4edfc0..30912a54f5 --- a/examples/amoeba/Test.sh +++ b/examples/amoeba/Test.sh @@ -1,66 +1,34 @@ -# run test problems +#!/bin/sh +# run test problems. +EXE=${1-../../src/lmp_mpi} +DATE=$(date +%1d%b%y) # dimer -../../src/lmp_mpi < in.water_dimer.amoeba.test -mv log.lammps log.water_dimer.amoeba.1.test -mv dump.water_dimer dump.water_dimer.amoeba.1.test +${EXE} -in in.water_dimer.amoeba -log log.${DATE}.water_dimer.amoeba.g++.1 +mpirun -np 4 ${EXE} -in in.water_dimer.amoeba -log log.${DATE}.water_dimer.amoeba.g++.4 -mpirun -np 4 ../../src/lmp_mpi < in.water_dimer.amoeba.test -mv log.lammps log.water_dimer.amoeba.4.test -mv dump.water_dimer dump.water_dimer.amoeba.4.test - -../../src/lmp_mpi < in.water_dimer.hippo.test -mv log.lammps log.water_dimer.hippo.1.test -mv dump.water_dimer dump.water_dimer.hippo.1.test - -mpirun -np 4 ../../src/lmp_mpi < in.water_dimer.hippo.test -mv log.lammps log.water_dimer.hippo.4.test -mv dump.water_dimer dump.water_dimer.hippo.4.test +${EXE} -in in.water_dimer.hippo -log log.${DATE}.water_dimer.hippo.g++.1 +mpirun -np 4 ${EXE} -in in.water_dimer.hippo -log log.${DATE}.water_dimer.hippo.g++.4 # hexamer -../../src/lmp_mpi < in.water_hexamer.amoeba.test -mv log.lammps log.water_hexamer.amoeba.1.test -mv dump.water_hexamer dump.water_hexamer.amoeba.1.test +${EXE} -in in.water_hexamer.amoeba -log log.${DATE}.water_hexamer.amoeba.g++.1 +mpirun -np 4 ${EXE} -in in.water_hexamer.amoeba -log log.${DATE}.water_hexamer.amoeba.g++.4 -mpirun -np 4 ../../src/lmp_mpi < in.water_hexamer.amoeba.test -mv log.lammps log.water_hexamer.amoeba.4.test -mv dump.water_hexamer dump.water_hexamer.amoeba.4.test - -../../src/lmp_mpi < in.water_hexamer.hippo.test -mv log.lammps log.water_hexamer.hippo.1.test -mv dump.water_hexamer dump.water_hexamer.hippo.1.test - -mpirun -np 4 ../../src/lmp_mpi < in.water_hexamer.hippo.test -mv log.lammps log.water_hexamer.hippo.4.test -mv dump.water_hexamer dump.water_hexamer.hippo.4.test +${EXE} -in in.water_hexamer.hippo -log log.${DATE}.water_hexamer.hippo.g++.1 +mpirun -np 4 ${EXE} -in in.water_hexamer.hippo -log log.${DATE}.water_hexamer.hippo.g++.4 # water box -../../src/lmp_mpi < in.water_box.amoeba.test -mv log.lammps log.water_box.amoeba.1.test -mv dump.water_box dump.water_box.amoeba.1.test +${EXE} -in in.water_box.amoeba -log log.${DATE}.water_box.amoeba.g++.1 +mpirun -np 4 ${EXE} -in in.water_box.amoeba -log log.${DATE}.water_box.amoeba.g++.4 -mpirun -np 32 ../../src/lmp_mpi < in.water_box.amoeba.test -mv log.lammps log.water_box.amoeba.32.test -mv dump.water_box dump.water_box.amoeba.32.test - -../../src/lmp_mpi < in.water_box.hippo.test -mv log.lammps log.water_box.hippo.1.test -mv dump.water_box dump.water_box.hippo.1.test - -mpirun -np 32 ../../src/lmp_mpi < in.water_box.hippo.test -mv log.lammps log.water_box.hippo.32.test -mv dump.water_box dump.water_box.hippo.32.test +${EXE} -in in.water_box.hippo -log log.${DATE}.water_box.hippo.g++.1 +mpirun -np 4 ${EXE} -in in.water_box.hippo -log log.${DATE}.water_box.hippo.g++.4 # ubiquitin -../../src/lmp_mpi < in.ubiquitin.test -mv log.lammps log.ubiquitin.1.test -mv dump.ubiquitin dump.ubiquitin.1.test - -mpirun -np 32 ../../src/lmp_mpi < in.ubiquitin.test -mv log.lammps log.ubiquitin.32.test -mv dump.ubiquitin dump.ubiquitin.32.test +${EXE} -in in.ubiquitin -log log.${DATE}.ubiquitin.g++.1 +mpirun -np 4 ${EXE} -in in.ubiquitin -log log.${DATE}.ubiquitin.g++.4 diff --git a/examples/amoeba/dump.water_box.amoeba.1 b/examples/amoeba/dump.water_box.amoeba.1 deleted file mode 100644 index 9019401850..0000000000 --- a/examples/amoeba/dump.water_box.amoeba.1 +++ /dev/null @@ -1,7227 +0,0 @@ -ITEM: TIMESTEP -0 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.67966 7.08769 17.9461 -18.0057 -16.954 4.82612 -2 2 7.80945 6.75579 18.2607 19.8034 12.4721 -7.17463 -3 2 8.72223 6.81424 17.0254 7.13784 0.0282027 3.08606 -4 1 18.5257 8.24445 6.83762 8.52147 14.2257 60.5703 -5 2 0.216892 7.89544 6.05003 12.0964 -15.6711 -53.3384 -6 2 0.444268 7.82601 7.5302 -13.3675 6.47926 -9.3119 -7 1 8.37906 18.5504 6.81463 24.6094 6.61103 -1.11969 -8 2 9.34042 0.098069 6.73406 -18.7879 -2.64022 0.747908 -9 2 7.93962 0.573676 6.26984 -2.09268 1.16699 2.67386 -10 1 6.58995 1.84432 11.7198 46.7475 -13.739 -10.5489 -11 2 5.88543 2.40231 11.9251 -37.1346 27.545 16.57 -12 2 6.18153 1.06275 11.3693 -7.36455 -17.4045 -5.52161 -13 1 7.1466 5.75358 2.33152 -53.3657 41.599 -1.38826 -14 2 6.36812 6.12603 2.86268 38.0857 -22.9036 -2.95785 -15 2 7.02502 6.29465 1.5182 16.1101 -20.4591 11.2904 -16 1 16.2164 10.1388 16.1382 -32.9296 19.8915 17.3579 -17 2 16.9509 10.2747 15.5847 32.6569 -1.09677 -20.2087 -18 2 15.8498 11.0405 16.2399 2.59134 -12.8635 2.30838 -19 1 10.6046 15.0374 2.30369 -9.45108 -28.933 -9.95229 -20 2 10.5292 14.3949 3.01849 1.67759 -0.529274 5.48943 -21 2 11.0236 15.78 2.70962 13.2591 21.3673 6.11781 -22 1 17.1624 8.24409 10.3708 10.41 5.9387 11.3227 -23 2 16.5528 8.68798 10.966 -4.81374 9.55532 3.583 -24 2 17.9421 8.82333 10.3208 -3.63548 -8.99367 -3.64514 -25 1 14.901 15.8652 16.3167 21.2892 -10.1645 16.79 -26 2 14.0225 16.1982 16.2525 -30.7371 12.6366 -7.00126 -27 2 14.9141 15.482 17.2099 1.64171 -7.21798 -3.7798 -28 1 12.1752 13.3771 0.408263 -10.449 7.39269 11.8256 -29 2 12.0579 13.8465 18.23 5.34035 -4.48355 -17.1718 -30 2 11.6217 13.8904 1.00796 2.45905 -0.157672 9.39156 -31 1 9.27358 5.34243 4.05546 -29.354 32.8373 13.3322 -32 2 8.64594 5.4665 4.83764 23.9402 -17.6274 -26.2044 -33 2 8.74177 5.68615 3.30282 4.39732 -15.4932 8.77495 -34 1 1.83016 4.27673 11.6495 -22.4867 33.9085 -11.1027 -35 2 1.70328 5.22377 11.9391 5.26663 -24.2909 -6.35354 -36 2 2.40811 3.85345 12.2597 16.6835 -12.3735 20.3319 -37 1 1.96438 6.83299 8.3731 -11.8866 6.09586 -26.8326 -38 2 2.49614 7.21578 9.0563 11.4719 0.0715494 18.6532 -39 2 1.81128 5.90585 8.57354 7.57659 -6.58781 5.32172 -40 1 5.40557 4.38899 7.93274 -5.84675 9.40812 -2.24834 -41 2 5.53738 3.43895 7.78131 -7.95286 9.95376 -0.129754 -42 2 4.75516 4.73491 7.29062 11.2407 -18.5615 7.61563 -43 1 3.23 2.92842 17.5524 1.14755 15.2746 17.0601 -44 2 3.93109 3.19827 16.9402 0.871842 10.3641 0.782189 -45 2 3.00444 3.70897 18.1497 2.9668 -26.2705 -22.3315 -46 1 7.4624 5.26283 6.13117 4.99569 4.7543 -2.87263 -47 2 8.02565 5.58849 6.88177 -21.8117 -10.641 -11.2175 -48 2 6.93508 4.45577 6.3254 15.5754 16.5621 10.3274 -49 1 9.77896 7.02384 11.9834 11.1892 -4.91774 24.9965 -50 2 10.2721 6.37256 11.5011 12.944 -11.2243 -3.64487 -51 2 9.1532 7.31587 11.3499 -25.3515 14.1302 -21.9158 -52 1 14.1167 3.54999 8.03003 -26.7224 -2.96987 -36.9282 -53 2 13.4732 4.22413 7.73132 14.0058 -9.36539 3.16858 -54 2 14.3809 3.80189 8.88487 12.5079 17.7406 36.8421 -55 1 4.82329 17.2568 4.03846 -17.1239 31.8599 -29.451 -56 2 5.49315 17.973 4.01308 -7.2715 -20.7015 10.2799 -57 2 4.18746 17.5412 3.33843 11.1391 -13.8034 10.6312 -58 1 16.4918 16.6259 10.0493 30.7319 18.7558 -40.9431 -59 2 16.1673 16.3226 10.8594 -24.9276 -14.9205 38.9888 -60 2 15.9925 16.2084 9.33562 -5.59472 -4.21747 7.16045 -61 1 1.94489 4.93323 0.49791 29.2037 9.87254 4.22328 -62 2 2.55322 5.26335 1.2053 -16.134 -9.14189 -14.6469 -63 2 2.08253 5.591 18.4408 -15.0883 -1.49688 2.64821 -64 1 11.816 13.3571 16.2711 -9.40148 3.94995 7.41554 -65 2 11.2371 12.6203 16.5671 11.2868 -0.226619 -16.3723 -66 2 12.2446 13.1893 15.4079 -8.93504 -7.51369 10.5349 -67 1 10.105 11.0651 16.9545 19.171 -30.5561 3.11717 -68 2 10.5674 10.1947 17.1295 -13.2328 27.8223 -6.21699 -69 2 9.25349 10.8067 16.5912 -4.96621 2.04172 2.74708 -70 1 11.7264 17.5421 13.4742 -3.04385 -27.7441 -11.1528 -71 2 12.2771 16.9836 12.8968 -5.80236 0.92931 5.24929 -72 2 12.1041 18.3936 13.317 3.92972 25.4072 2.69815 -73 1 6.33029 9.31911 12.2264 14.5686 -26.7823 -24.0739 -74 2 7.02603 8.96242 11.6353 -16.9594 2.64581 0.0898615 -75 2 6.81249 9.95941 12.7172 6.645 23.591 18.9185 -76 1 16.2187 12.7249 2.70186 -8.60429 -40.8729 7.98732 -77 2 17.0292 13.1566 2.50302 21.6794 20.3416 -10.6726 -78 2 15.4982 13.3357 2.61812 -11.4268 23.7847 2.88762 -79 1 0.637202 12.5625 5.84914 -31.8402 8.87564 3.58131 -80 2 0.892312 12.5507 4.90771 -4.9886 -2.92912 11.9697 -81 2 18.3039 12.804 5.85329 37.806 -5.77498 -8.15105 -82 1 5.19922 16.3781 18.5047 -8.79571 2.1563 -13.4584 -83 2 5.80284 15.8543 17.9455 2.86332 8.92403 13.1762 -84 2 5.67034 16.9636 0.462296 7.01287 -6.10758 -1.1835 -85 1 0.510145 7.62945 4.0545 45.1401 15.6351 -20.049 -86 2 18.5719 8.14656 3.45296 8.17292 -14.6601 7.70417 -87 2 1.46496 7.74082 3.66917 -48.4928 -0.554047 23.6518 -88 1 3.14672 8.89584 6.52626 -55.2927 3.32392 -1.46176 -89 2 3.50609 8.59991 7.35294 11.5609 -2.03159 9.82262 -90 2 2.14573 8.92962 6.68203 43.6989 0.357582 -10.1043 -91 1 7.30854 10.3037 16.1717 1.78466 -0.469392 13.5048 -92 2 6.56213 10.4624 15.5802 -0.177974 -0.17468 9.69093 -93 2 6.99303 10.278 17.1118 -1.93161 2.46429 -18.5659 -94 1 11.1122 1.06968 4.98939 -2.5529 -18.3754 16.0671 -95 2 11.0776 1.97142 4.64864 2.28669 -2.46607 -13.2595 -96 2 10.7048 0.433547 4.37027 3.43033 14.549 -3.59534 -97 1 4.45204 2.70061 13.2052 -5.66348 -30.5004 33.0628 -98 2 4.60333 3.05865 14.0914 -1.92534 16.2672 -14.1546 -99 2 4.38645 1.737 13.4626 -0.349226 19.9023 -23.5316 -100 1 8.42792 10.0237 1.78469 -10.3917 -19.899 15.7952 -101 2 8.3405 10.6377 2.53622 4.61332 0.207175 -2.25283 -102 2 8.49672 9.11244 2.17467 4.01989 28.7847 -10.326 -103 1 10.5335 1.75383 15.546 -34.1458 -0.453574 1.15961 -104 2 11.3977 1.82718 15.9216 24.1476 -5.37633 -0.0681618 -105 2 10.5608 1.78317 14.5837 3.50677 3.31298 -0.339701 -106 1 2.77693 12.941 7.74821 -10.4378 -0.583625 -1.53852 -107 2 3.28797 13.5733 7.23382 6.48403 3.62296 3.43855 -108 2 1.98704 12.8256 7.20013 3.29426 -8.64685 -0.0486837 -109 1 3.63517 11.6895 5.33963 -11.8109 -10.1864 -4.68879 -110 2 3.35385 11.0502 6.03137 5.66752 13.6786 -16.6554 -111 2 2.8758 11.855 4.74058 12.1084 -4.04172 11.1294 -112 1 6.88803 14.474 16.8428 -11.4129 11.5698 10.6698 -113 2 7.55973 13.8293 16.6383 5.64016 -3.74285 -2.32739 -114 2 6.60381 14.8838 16.0165 -1.10143 -9.42407 -1.70294 -115 1 14.1722 14.5374 3.41536 22.8916 -3.95473 -24.8295 -116 2 13.6514 15.2845 3.14096 -10.2906 15.0357 0.984662 -117 2 13.8512 14.2508 4.25439 -13.7068 -8.63673 17.9444 -118 1 8.28226 18.1809 16.0824 -12.751 -14.2632 -6.38017 -119 2 8.77677 17.3494 16.3071 3.86396 27.0257 -3.69586 -120 2 8.7603 0.384816 15.9919 13.8336 -15.3184 3.9152 -121 1 4.73724 1.61643 4.90111 4.42093 34.2728 -25.3552 -122 2 3.96969 2.16837 5.15263 7.5353 -10.5013 -8.47368 -123 2 5.18465 2.1484 4.15475 -16.3947 -25.6944 40.0476 -124 1 15.1457 12.8616 16.4403 -17.2871 -9.38827 44.2976 -125 2 14.6041 12.8692 17.2613 20.1997 8.40389 -10.3991 -126 2 14.49 12.6307 15.8136 -19.9308 -5.03226 -40.1466 -127 1 15.779 18.3837 16.786 46.4421 11.1965 42.4368 -128 2 16.5108 18.615 17.4688 -40.0732 -8.23978 -31.409 -129 2 15.7694 17.4186 16.7687 -10.9286 -0.13557 -0.275231 -130 1 1.1383 1.1331 16.5571 -3.78806 10.8903 6.59298 -131 2 1.96551 1.50352 16.9177 -13.4358 3.04324 -1.88802 -132 2 0.420521 1.53444 17.0916 18.9396 -8.74897 -5.5358 -133 1 18.0817 4.5907 15.863 15.5867 -18.8741 -0.0488223 -134 2 18.5818 3.91936 15.3489 -11.2031 15.1049 7.34982 -135 2 18.5602 4.7339 16.6874 -0.349245 -1.77666 -1.18458 -136 1 12.22 16.9378 16.1148 -5.50141 -11.6153 60.0453 -137 2 11.409 16.6934 16.6676 25.9686 4.83442 -31.2532 -138 2 11.9646 17.3216 15.2917 -16.184 2.10738 -25.7541 -139 1 15.8709 2.55221 17.9707 -0.937802 24.4841 -15.6355 -140 2 15.7355 3.48355 18.2574 7.57333 -26.0521 3.95198 -141 2 15.6659 2.59235 17.0072 3.66916 -5.77112 18.206 -142 1 6.70868 13.791 10.2637 2.56639 25.7323 0.00368182 -143 2 6.59347 13.548 11.1958 -0.357243 -4.92282 -5.01928 -144 2 6.58252 13.0514 9.6765 -3.72683 -17.1721 -0.802691 -145 1 10.146 18.2027 2.80372 18.7695 36.9578 -11.0057 -146 2 10.2207 0.331961 2.18345 -3.04248 -21.6078 13.7214 -147 2 9.26571 17.8868 2.67703 -19.5044 -8.44618 -8.21612 -148 1 2.97538 17.748 6.06078 -25.8303 0.797173 6.8887 -149 2 2.09399 17.6473 5.67013 0.763714 -3.05404 12.9421 -150 2 3.45883 17.8838 5.26396 31.3429 0.483929 -10.2997 -151 1 12.558 17.0134 7.97028 5.92903 -16.4499 -7.28316 -152 2 11.9572 16.2512 7.82085 0.921176 10.9238 13.6165 -153 2 12.4657 17.4524 8.83591 -10.9555 -3.32417 -4.29455 -154 1 14.8795 15.2862 8.28544 4.29768 -18.9738 42.4504 -155 2 13.9824 15.6136 8.40666 -1.92729 9.60106 -14.0248 -156 2 15.2312 15.4641 7.43118 3.9302 10.2131 -33.7787 -157 1 17.5429 18.3228 0.375372 -51.2916 -3.32975 -15.7386 -158 2 18.116 17.6308 0.128652 39.2354 -21.6017 -8.51882 -159 2 17.9698 0.288559 0.934677 25.0864 23.4945 21.3611 -160 1 0.910209 10.3712 1.41143 1.2541 -53.8465 46.4292 -161 2 0.158544 9.88347 1.87089 19.8792 18.5163 -27.3041 -162 2 0.565924 11.0969 0.944383 -23.7591 37.8535 -27.1782 -163 1 1.55407 12.175 3.31087 17.0236 24.8743 53.6813 -164 2 1.36245 11.4802 2.72234 -7.32763 -23.5838 -35.6732 -165 2 1.61623 13.0206 2.87285 0.136729 5.19924 -18.0355 -166 1 0.543127 17.2543 4.88609 31.8084 34.0538 -50.8525 -167 2 0.11032 17.9772 5.31124 -21.3387 12.8349 12.3342 -168 2 0.420366 16.4266 5.2673 -11.294 -44.4064 35.6607 -169 1 1.10053 1.01949 9.38768 20.2638 -3.47079 3.57058 -170 2 1.46081 0.575286 10.1589 5.67003 5.93636 13.5245 -171 2 0.265613 0.594128 9.34525 -28.6257 -3.15214 -10.2647 -172 1 16.8007 2.32783 13.2877 6.99662 17.0137 -29.7497 -173 2 17.0701 2.57314 12.3549 -10.9982 -8.19012 27.7721 -174 2 16.4263 1.43993 13.282 0.147057 -7.47121 1.20179 -175 1 2.45231 15.8283 12.1942 24.161 -10.1121 18.9704 -176 2 2.8623 15.5513 13.0537 -7.72007 6.59246 -26.0318 -177 2 2.91392 15.3801 11.4615 0.0476102 5.48907 2.61928 -178 1 16.435 15.531 5.9458 18.7492 36.0842 -19.2976 -179 2 17.3808 15.5177 6.20547 -11.8351 -4.55683 5.24266 -180 2 16.4147 16.2211 5.22063 -11.381 -14.928 22.2973 -181 1 5.84547 5.02056 11.8065 17.7106 -18.2202 -11.4458 -182 2 5.55799 5.91374 11.8891 -12.2572 20.16 10.1838 -183 2 5.09 4.45915 11.9819 -6.52029 -3.58907 3.63352 -184 1 15.2214 4.86555 0.731755 -13.1216 -14.4231 22.9417 -185 2 14.6776 4.45845 1.47821 22.203 16.7553 -20.5876 -186 2 14.6696 4.95834 18.5986 -12.3693 6.08689 2.65647 -187 1 16.3401 16.2933 2.11217 18.14 -13.9799 -32.9854 -188 2 16.0666 16.7695 2.87319 -13.0548 23.8975 25.5489 -189 2 16.7601 16.9279 1.50378 -12.2165 -0.858221 10.4248 -190 1 0.305885 4.87877 3.79118 -8.03527 51.7998 21.7755 -191 2 0.299338 5.85541 4.09758 -2.9952 -44.8334 -24.4202 -192 2 1.16991 4.5635 4.03062 6.79251 -10.5604 -0.715716 -193 1 2.92501 14.9782 15.0356 -0.55527 3.1583 33.427 -194 2 3.0159 14.7264 15.9987 -0.365372 -5.40078 -25.4532 -195 2 2.35392 15.7535 15.1247 4.98076 9.37108 -6.84819 -196 1 1.1115 14.5727 9.55731 53.2995 18.2393 -15.0567 -197 2 2.08491 14.4157 9.46275 -24.2978 21.5236 -5.71591 -198 2 0.897072 13.7408 9.90248 -27.8007 -35.1999 18.1171 -199 1 13.6501 16.6688 11.5433 6.47975 17.456 -8.04391 -200 2 13.4697 17.4567 10.9694 -3.73037 -22.0736 15.6897 -201 2 13.5721 15.8897 10.9842 -9.76738 -0.866763 -1.05724 -202 1 4.73098 1.47842 0.720986 0.301824 -3.12152 0.469647 -203 2 4.27169 1.98826 0.034225 -8.26683 -3.93854 8.43126 -204 2 4.11741 0.788607 1.06182 2.96071 12.6313 -1.58966 -205 1 1.42158 18.4663 11.9139 -14.1117 26.2958 -21.249 -206 2 1.21766 0.394331 12.6648 1.16138 0.455671 2.39682 -207 2 1.94844 17.765 12.2423 13.6408 -23.7742 11.0988 -208 1 11.5498 10.1018 4.11619 25.3456 17.7005 -19.3629 -209 2 11.5687 10.5955 3.24216 -3.14233 -16.3641 23.7483 -210 2 12.4899 10.1059 4.45555 -25.4417 -1.6091 -14.3563 -211 1 8.38254 12.182 3.76573 -28.852 -4.31545 3.66513 -212 2 9.25863 12.501 4.06076 -17.1001 4.9792 7.32521 -213 2 7.63736 12.4251 4.40785 39.3791 -3.23553 -14.7997 -214 1 14.3228 4.03714 3.29709 9.27375 -1.14036 13.2131 -215 2 14.8928 4.14179 4.10547 -9.51715 0.900554 -20.2647 -216 2 13.4701 4.45558 3.48891 4.64833 -1.13545 4.69814 -217 1 5.58188 1.78199 7.50513 -29.4992 -43.0538 46.7434 -218 2 5.0172 1.13958 8.12095 30.2312 35.5173 -41.7355 -219 2 5.33078 1.59122 6.59529 -0.079259 -3.9625 -11.0752 -220 1 17.9086 1.12503 4.88467 2.95857 -4.16946 -9.18468 -221 2 18.4038 1.54032 4.14207 -4.82318 -1.26447 16.1692 -222 2 17.6814 1.78344 5.55455 4.62183 1.86586 -4.7268 -223 1 6.83101 9.39303 4.49716 -16.0719 2.4093 -32.0921 -224 2 6.83675 9.57499 5.42715 5.68499 0.0447418 21.7322 -225 2 7.66807 8.99049 4.24996 11.5264 2.90932 7.40733 -226 1 2.71406 14.9654 1.962 -15.6661 -3.22344 -28.3015 -227 2 3.33343 14.7912 2.66354 12.1361 -6.91733 6.37301 -228 2 3.09502 14.6645 1.10257 -2.31521 10.6903 23.881 -229 1 17.279 12.8803 13.1283 -15.852 18.187 11.8592 -230 2 16.4044 13.2339 13.3283 -9.52452 -19.4408 0.302495 -231 2 17.6948 13.7346 13.0834 29.0619 4.95471 -11.8483 -232 1 15.0196 10.5818 1.38314 -38.2265 -36.9922 -31.977 -233 2 15.5102 11.1963 1.85791 34.2907 40.991 28.9525 -234 2 14.3351 11.0964 0.933298 3.32659 -5.3471 5.33786 -235 1 5.71789 6.95838 4.52856 0.683996 -27.8748 7.64407 -236 2 5.85266 7.87985 4.34179 3.58991 17.4746 0.820156 -237 2 6.44364 6.70841 5.13514 -10.315 -1.76088 -5.92415 -238 1 8.12142 8.26262 10.159 -0.695069 1.43108 44.445 -239 2 8.58519 8.93965 9.66877 7.60931 4.76567 -12.7632 -240 2 7.56021 7.74854 9.59836 -11.8614 -6.52029 -23.2391 -241 1 13.5311 18.2901 5.8079 -10.639 -13.2321 14.1155 -242 2 12.703 0.102298 5.56963 3.89465 4.4637 5.13268 -243 2 13.2939 17.6289 6.50758 1.00889 22.2284 -14.4481 -244 1 0.327324 2.56344 0.113251 1.70035 12.7901 -0.992224 -245 2 18.009 2.52214 18.5736 8.63965 15.9711 4.89881 -246 2 0.724331 3.48299 0.160564 -21.1536 -24.6374 0.514976 -247 1 12.6396 10.9599 9.76875 -56.8672 19.3176 -11.2335 -248 2 11.6552 10.7306 9.75031 35.1307 23.7735 -5.55284 -249 2 12.944 10.1383 10.0842 27.9729 -33.5927 10.4043 -250 1 0.789377 12.2851 11.08 11.4395 6.49483 14.2632 -251 2 18.4919 12.3017 11.2021 -18.2818 -3.30898 -6.09679 -252 2 1.09088 12.7637 11.8722 5.75277 -12.0493 -6.6955 -253 1 5.04567 7.2193 13.4912 -21.0137 -4.20407 -15.1033 -254 2 5.59899 7.84649 13.0247 8.33052 12.0635 4.31379 -255 2 5.48047 6.97898 14.3058 12.3979 0.954472 8.53674 -256 1 1.28609 6.99027 11.837 -51.8154 -68.8711 -15.2848 -257 2 0.481329 7.14037 11.2978 13.8945 0.267944 10.341 -258 2 1.71601 7.79102 11.8803 31.2664 60.1884 9.92158 -259 1 15.4442 9.46712 12.3088 17.5832 34.764 29.4487 -260 2 15.6103 10.4448 12.4444 -11.1607 -30.7672 -13.8763 -261 2 15.5582 9.10301 13.208 -6.74487 -0.409264 -16.2653 -262 1 16.6404 12.9744 5.44078 0.476019 -21.9889 6.56196 -263 2 16.2955 13.8866 5.54247 3.20084 -14.9841 -16.6056 -264 2 16.51 12.593 4.54035 -6.85686 22.0547 12.2483 -265 1 6.17495 10.0683 0.210584 -24.8048 -7.78292 -31.6597 -266 2 5.35839 10.4511 0.557392 3.36584 -0.936069 -2.46609 -267 2 6.76092 10.0813 0.943985 27.7338 0.90169 16.297 -268 1 12.3644 6.05734 4.04236 -18.3706 -38.3329 30.2118 -269 2 12.4738 6.70802 3.38308 -4.23006 32.9396 -25.2938 -270 2 11.4212 5.77124 4.03221 17.6012 8.78206 -0.800798 -271 1 0.124733 12.8266 0.203961 3.20067 -1.28022 -4.47052 -272 2 0.029974 13.5935 0.786871 -4.13202 -3.19163 0.984476 -273 2 18.185 12.9963 18.0877 7.32574 2.49628 4.77591 -274 1 3.83931 18.5785 8.61972 20.3146 -6.32916 -11.386 -275 2 3.58625 18.36 7.70531 -8.03976 -3.33875 5.01892 -276 2 3.07994 0.282626 9.06556 -19.534 7.19375 -0.404578 -277 1 7.37599 17.2741 4.45241 46.8945 31.0513 1.9622 -278 2 8.02493 17.9603 4.76808 -26.2103 -24.7083 -3.79352 -279 2 7.47725 17.3636 3.49301 -14.0292 -8.10987 6.13371 -280 1 9.20909 17.0315 12.2197 40.0448 -1.21715 18.2255 -281 2 9.48765 16.172 11.8421 -14.9023 11.2095 -3.08284 -282 2 9.99892 17.2887 12.7762 -22.6762 -6.36186 -10.9913 -283 1 13.3284 13.0292 7.94175 -54.0325 -32.963 -10.3586 -284 2 13.0533 12.253 8.47808 14.6554 7.99008 1.85075 -285 2 14.1985 13.2855 8.14946 35.8516 11.3519 14.341 -286 1 14.9871 2.94126 15.3478 14.8638 12.3357 -7.44451 -287 2 14.2243 2.52816 14.9303 4.35222 -7.49481 -2.56315 -288 2 15.7054 3.02501 14.6718 -19.1947 -5.47381 11.1555 -289 1 9.85637 15.4939 17.0026 4.34281 7.61827 -6.92944 -290 2 10.2013 14.6312 16.7411 4.19591 2.79737 -1.68983 -291 2 9.35728 15.3668 17.8085 -9.66212 -2.87408 7.84053 -292 1 11.2848 8.23994 16.5492 3.25751 34.7591 1.5155 -293 2 10.8315 7.75123 15.8747 -12.3664 -15.1549 -6.58201 -294 2 11.7506 7.62533 17.1016 5.33248 -14.8245 8.28699 -295 1 3.77097 18.1898 16.7118 4.01905 33.5947 11.0152 -296 2 4.24576 17.6768 17.3569 8.65949 -22.0954 6.28955 -297 2 3.7978 0.441972 17.1008 -4.25038 -14.6471 -12.4326 -298 1 2.20581 4.09889 8.95874 2.08991 2.93543 4.28652 -299 2 3.00197 3.55544 8.74643 -14.7124 14.9899 14.3923 -300 2 2.10364 4.24367 9.94001 10.2614 -16.6264 -23.5165 -301 1 9.9196 10.3581 9.75231 -25.3187 14.4865 -18.1673 -302 2 9.34403 11.1055 9.40387 23.5511 -18.6954 16.391 -303 2 9.87032 10.282 10.7171 2.48436 10.3271 -7.39297 -304 1 9.73405 0.807167 10.8572 20.2474 21.386 4.54274 -305 2 9.58177 18.5811 11.2204 -17.7151 -14.7389 -0.277185 -306 2 9.10878 1.03014 10.1675 -11.7891 -3.63679 -6.29284 -307 1 9.18221 15.2247 10.2123 -13.9791 -9.46207 -17.3808 -308 2 9.04674 16.0847 9.7631 0.486754 -17.6411 9.75771 -309 2 8.3908 14.6843 9.94105 18.1048 12.7648 16.7376 -310 1 1.00316 9.27987 10.329 16.2357 -30.0069 -12.307 -311 2 1.16727 10.1904 10.5724 12.5584 13.4462 -0.132091 -312 2 1.84996 8.76119 10.1498 -29.1191 35.4904 9.82697 -313 1 16.8004 4.89338 8.19813 20.3933 -12.8673 28.5682 -314 2 16.1748 5.31624 8.83318 13.8703 -8.22156 -17.3769 -315 2 17.4877 4.38941 8.71628 -28.7666 17.1718 -13.9408 -316 1 14.6379 14.6893 0.402347 -11.3933 -1.08114 12.583 -317 2 14.9609 15.3376 1.05877 1.73558 -10.8431 -5.12344 -318 2 13.9048 14.1906 0.841144 16.133 14.0369 -13.7985 -319 1 3.51181 11.0525 9.63829 3.71178 7.51059 -9.42611 -320 2 3.41507 11.3617 10.5484 4.21267 3.5616 -2.2445 -321 2 3.25155 11.8076 9.06383 -1.86739 -11.3951 3.16022 -322 1 11.0289 10.8695 1.26208 17.5529 18.9634 -6.32419 -323 2 11.1535 11.716 0.753779 -2.53448 -25.7082 13.9861 -324 2 10.1142 10.5923 1.16471 -5.76816 1.63272 -1.45278 -325 1 13.2239 7.06188 12.8977 -31.5053 10.0751 -2.41927 -326 2 14.1381 6.84046 12.8922 27.4331 -7.40558 0.979603 -327 2 12.7471 6.22139 12.9668 2.74296 5.12722 -5.48309 -328 1 9.62584 1.88878 0.937813 20.2039 -2.98483 37.6532 -329 2 8.77484 2.11506 0.623903 -27.5663 2.83673 -14.773 -330 2 10.1764 1.70882 0.191067 9.03311 -1.803 -18.3794 -331 1 10.6054 13.537 4.7508 -5.88392 -4.211 -2.61457 -332 2 11.3208 12.9359 5.04367 -2.43279 15.5075 -5.53386 -333 2 10.4128 14.1619 5.47507 10.6777 -11.2442 -5.71889 -334 1 14.2525 1.6915 10.8868 22.6682 20.2673 6.9187 -335 2 15.0842 1.26497 10.6465 -0.175006 -8.05208 -4.1062 -336 2 14.5069 2.62992 10.8824 -12.4791 -0.486299 1.09093 -337 1 14.6678 12.4248 11.7157 -13.2082 -11.6835 -6.16669 -338 2 15.5574 12.5766 11.3177 -21.8957 -10.6844 -5.73724 -339 2 14.0022 11.9667 11.1187 29.6297 15.7618 7.64488 -340 1 8.24065 5.08218 9.78509 -6.47861 44.5837 29.4664 -341 2 7.45364 5.10173 10.3836 14.047 -11.9893 -18.2698 -342 2 8.36822 4.22882 9.41503 -9.58488 -33.9934 -8.19516 -343 1 1.59893 16.8132 18.3262 1.96117 45.1636 -18.3395 -344 2 1.99225 17.1675 17.4932 -11.7114 -3.37836 17.8399 -345 2 1.72693 15.8931 18.2458 8.8364 -33.8164 2.61771 -346 1 1.43382 17.2563 15.3383 72.5903 -10.7327 -13.0674 -347 2 1.32309 18.1562 15.5759 -7.01853 28.114 11.2541 -348 2 0.623143 16.841 15.3782 -65.0193 -20.0106 1.99827 -349 1 3.73599 5.55499 6.2196 -15.153 37.171 -3.6345 -350 2 3.32092 6.26594 6.76194 -0.427016 -18.6419 -6.59332 -351 2 4.19567 6.05321 5.52665 9.16489 -2.39818 -0.177123 -352 1 12.357 9.41487 14.1826 14.7553 -23.0333 -0.513454 -353 2 12.9591 8.63784 13.9021 -31.7094 29.7183 13.6876 -354 2 11.936 9.15457 15.0346 15.6336 0.764049 -11.787 -355 1 4.0362 15.2647 6.90572 29.1452 22.7898 -8.55589 -356 2 3.45744 16.0249 6.7945 -6.03593 0.633302 -6.25525 -357 2 4.92941 15.6518 6.66696 -24.7672 -22.8121 8.07817 -358 1 0.606517 8.56128 14.8606 8.16327 11.3924 -6.42857 -359 2 0.498099 9.52604 14.9437 -1.3098 -5.53798 5.35752 -360 2 1.28855 8.50016 14.167 -7.84877 -5.15776 5.22176 -361 1 12.9763 8.3683 10.3434 -0.844759 8.90572 -31.1716 -362 2 13.7163 7.90436 9.89822 -4.62341 -2.31264 17.3373 -363 2 12.9003 8.0957 11.2534 8.39581 -13.8091 14.665 -364 1 15.2983 7.63672 3.47583 -36.1974 -22.3868 30.0346 -365 2 14.5024 7.10501 3.29647 15.8969 13.8763 -24.8874 -366 2 15.2922 7.47095 4.43335 27.1257 13.219 -1.62631 -367 1 17.3208 6.63818 0.028906 -14.8751 21.4285 -7.11338 -368 2 16.7479 6.05403 0.554933 2.23596 0.744461 -7.2242 -369 2 16.7141 7.27151 18.2009 9.57247 -21.991 17.917 -370 1 8.79355 6.92545 7.84172 -22.0329 -24.5159 21.3067 -371 2 9.63968 7.32585 7.85068 36.717 16.3192 -5.46325 -372 2 8.77688 6.39871 8.67404 -5.56167 6.19415 -17.3543 -373 1 12.3209 0.607808 1.1741 -8.60043 -0.59496 -5.94607 -374 2 12.995 1.15082 1.58835 11.0262 -7.11766 4.69751 -375 2 12.79 18.5825 0.66073 -1.01688 3.73434 3.9163 -376 1 5.68514 15.097 14.5145 8.08213 26.2607 -13.8654 -377 2 4.72797 15.1695 14.4772 -8.65505 -1.66018 8.38379 -378 2 6.02476 15.8935 14.032 -4.56821 -16.9623 16.8148 -379 1 3.822 6.53853 1.67803 10.5239 -7.29529 -10.476 -380 2 3.54968 7.33117 1.17576 -0.94291 -9.86176 19.1013 -381 2 3.81642 6.7886 2.60252 -1.1437 7.90849 5.70077 -382 1 3.89262 11.6088 12.227 12.6183 0.535598 5.61903 -383 2 4.72051 12.1032 12.348 1.21499 -6.42147 -0.654839 -384 2 3.26281 12.0921 12.7526 -15.9809 8.56892 5.74885 -385 1 5.45444 3.88172 15.8755 8.44756 62.1439 23.7417 -386 2 5.90627 3.24049 15.3708 26.1603 -31.2362 -14.1171 -387 2 6.11665 4.65725 15.9739 -35.5554 -35.0069 -5.06549 -388 1 14.4636 10.317 4.39501 5.54347 -18.2961 -43.8287 -389 2 14.9051 9.88853 5.13417 0.162303 -5.91623 3.64337 -390 2 14.7084 9.81768 3.53446 -11.8135 21.0668 42.8202 -391 1 7.94949 17.2895 9.24469 -10.6799 8.8199 -1.02562 -392 2 7.23447 17.5423 9.86969 8.35341 2.50468 -15.9799 -393 2 8.01085 17.8889 8.47627 -8.2125 1.31495 9.33291 -394 1 4.4986 14.4237 3.96317 23.4879 4.54475 27.495 -395 2 4.89523 15.3318 4.14709 -14.6852 -27.1979 0.729547 -396 2 4.80237 13.7713 4.67129 -11.1841 28.5155 -20.9146 -397 1 14.3358 7.38467 15.7635 18.2582 5.36164 1.70543 -398 2 15.2401 7.23754 15.391 -25.5283 4.5174 14.2628 -399 2 14.4998 7.83446 16.6232 -7.00614 -11.7321 -15.3353 -400 1 2.86875 18.2246 1.90934 11.7547 29.7641 47.6357 -401 2 2.54447 17.7626 1.17928 -20.4445 -34.8995 -41.4626 -402 2 2.08284 18.4154 2.45796 12.4063 3.86937 -8.17484 -403 1 7.96139 1.61197 4.52525 30.3503 -5.61589 29.1814 -404 2 7.4985 1.83317 3.72811 -5.85178 12.6793 -14.6648 -405 2 8.84188 2.051 4.57628 -22.8061 -6.44347 -10.2559 -406 1 2.69247 14.1251 17.7583 -44.9975 -8.30966 9.027 -407 2 1.78944 13.8074 18.0556 29.9332 0.951363 -12.1679 -408 2 3.33089 13.517 18.1683 -0.885538 6.08231 -6.55793 -409 1 0.711797 1.68055 13.8626 46.1903 -0.903658 -18.4125 -410 2 0.854596 1.56791 14.7929 -3.1534 -4.53792 18.4431 -411 2 18.4557 1.86826 13.7064 -36.4408 7.03813 3.66844 -412 1 4.5582 18.5986 13.9691 16.7448 -5.62304 -20.7496 -413 2 5.37614 18.0918 13.7297 -17.5024 17.6116 13.2075 -414 2 4.4096 18.4453 14.9034 -5.9637 -5.97884 8.59903 -415 1 7.10973 0.453475 18.3742 -15.9095 45.4284 35.234 -416 2 6.99644 0.098599 17.5235 1.36411 -17.312 -40.4978 -417 2 6.34312 1.05085 18.5323 11.251 -17.9428 -0.916775 -418 1 16.0934 18.4421 14.1505 -12.1616 -21.5095 -38.715 -419 2 15.444 17.7866 13.7542 19.2119 24.6311 23.4234 -420 2 16.0379 18.4915 15.109 -11.392 0.0248185 1.48898 -421 1 10.1156 4.52417 16.2956 -62.1497 -10.7811 -30.3439 -422 2 10.9808 4.34247 16.5381 55.5233 -0.530433 19.4573 -423 2 9.84863 3.69679 15.8473 1.30878 12.8229 10.5952 -424 1 15.8226 17.9425 4.41327 -8.6596 2.53656 28.4341 -425 2 16.5547 18.5732 4.53052 -7.53986 -1.28134 -1.76301 -426 2 15.1071 18.2295 5.06915 24.8326 -13.5436 -35.3744 -427 1 6.9246 17.3574 13.7412 35.4232 12.1969 -4.79491 -428 2 7.49648 17.8115 14.4369 -19.095 -19.6264 -17.6052 -429 2 7.52703 17.1963 12.9658 -8.44681 6.90552 21.4872 -430 1 13.2892 6.57209 6.73437 -47.4462 -6.01427 11.894 -431 2 14.2146 6.66317 6.83486 37.5911 0.460957 -13.6759 -432 2 13.0394 6.38579 5.82242 8.60231 0.411312 -6.48828 -433 1 7.6616 2.3861 9.17526 11.1339 -5.58665 -35.6695 -434 2 7.32169 2.39592 10.0555 -17.0215 -5.04529 20.6135 -435 2 6.95914 2.1022 8.53308 18.7558 7.43711 21.2842 -436 1 15.1464 14.8771 13.6482 -7.73724 1.21311 0.537171 -437 2 15.0308 15.0223 14.6069 -1.84691 1.26092 -11.2626 -438 2 14.3194 15.1152 13.1798 14.9291 -3.65447 11.731 -439 1 9.29105 8.34315 3.70472 21.3149 -22.535 5.81715 -440 2 10.1776 8.75859 3.73678 -10.082 3.55323 2.49013 -441 2 9.48378 7.39942 3.88081 -6.26995 14.6936 -2.40173 -442 1 17.6854 13.4687 16.4528 7.27147 30.461 -18.2669 -443 2 16.7357 13.4337 16.3398 -4.89197 -8.49248 4.47316 -444 2 17.8844 14.3284 16.0065 3.65909 -18.1112 10.9221 -445 1 5.04883 10.6547 2.58751 22.4142 -14.5409 3.1837 -446 2 5.87017 10.3468 3.04382 -22.783 5.18619 -3.79272 -447 2 4.55197 11.1441 3.22928 -6.35653 9.92745 13.9967 -448 1 3.70566 8.3683 10.3381 0.421872 -35.3081 -1.7593 -449 2 3.86061 9.29726 10.2176 3.60826 23.2513 -1.90293 -450 2 3.86652 8.14601 11.2715 -1.83662 8.64514 -7.63686 -451 1 16.1079 7.11641 6.33859 18.7251 -13.7954 -9.96454 -452 2 16.7241 7.70559 6.80408 -7.87205 -5.85527 -7.24175 -453 2 16.6678 6.33083 6.12136 -22.8952 10.0887 6.36104 -454 1 15.2027 7.00502 9.1117 -13.5711 31.2066 -33.9348 -455 2 16.009 7.42176 9.46585 -10.2898 -7.03399 -7.73296 -456 2 14.9881 7.51375 8.25647 13.8068 -20.3115 41.0185 -457 1 6.4525 13.1649 12.9201 -16.9811 1.25576 1.12717 -458 2 7.2977 12.7289 13.0561 1.55279 -4.02118 8.73008 -459 2 6.25327 13.7237 13.7059 9.12735 -9.15034 -19.1848 -460 1 12.1145 4.49786 13.0694 62.3048 41.2439 -0.723073 -461 2 12.3852 4.68406 13.9868 -14.3297 -10.0558 -0.292641 -462 2 11.3952 3.9317 13.0199 -52.2119 -35.1204 4.15665 -463 1 11.3323 8.18365 7.8522 27.7169 3.03613 12.328 -464 2 12.0901 7.73501 7.43634 -12.9205 -4.29619 -7.69129 -465 2 11.7651 8.45102 8.68662 -18.4456 -0.736999 -3.04515 -466 1 17.1666 10.776 7.42179 36.4822 -17.3878 -25.363 -467 2 17.7906 10.0723 7.08441 -17.5934 13.4566 22.3886 -468 2 17.2793 11.4524 6.73733 -15.3427 2.84073 7.18141 -469 1 5.22802 18.1471 11.05 -23.1388 -14.8798 2.48444 -470 2 4.73762 18.1049 11.901 7.4508 0.565766 -17.6495 -471 2 4.62535 17.7417 10.374 17.7336 12.8347 12.9373 -472 1 7.56653 17.6363 1.80821 4.35794 -3.26776 57.5888 -473 2 7.65741 16.7768 1.42856 9.05039 -19.6913 -22.9027 -474 2 7.35855 18.2549 1.13994 -1.37991 13.1573 -30.1972 -475 1 1.85092 12.9256 13.6076 18.7065 20.702 19.2299 -476 2 1.72104 12.4156 14.4258 -5.54537 -0.960406 -11.4426 -477 2 2.19932 13.7866 13.9501 -8.88955 -22.8153 -6.43965 -478 1 9.73868 6.79159 14.8001 -20.0718 45.6966 0.235719 -479 2 9.95236 5.95211 15.1529 12.0129 -40.6355 11.2206 -480 2 9.967 6.84408 13.8723 5.59208 -5.10263 -8.66058 -481 1 15.2087 4.3972 10.7794 -27.6923 -26.0969 -27.5028 -482 2 16.0082 3.89203 10.8637 26.1176 6.2885 5.33656 -483 2 15.2102 5.16148 11.3322 8.48984 16.211 19.3779 -484 1 11.1963 6.12482 0.150068 -21.1972 -23.7011 14.8212 -485 2 11.2381 5.20796 0.481504 11.4486 12.9471 -10.1704 -486 2 10.2374 6.21547 18.6186 14.0424 14.8346 -3.67395 -487 1 0.19533 11.3359 15.1413 -20.6703 11.3325 -28.7309 -488 2 18.4021 11.874 14.3993 9.91215 -19.3636 27.3138 -489 2 18.4481 11.661 15.9631 4.36494 9.01906 -3.16307 -490 1 7.06882 9.13032 7.26059 -19.4655 -1.24154 14.8953 -491 2 6.55985 8.40099 7.69941 12.6354 16.9737 -16.1687 -492 2 7.9725 8.82922 7.21375 8.43039 -5.65083 0.275054 -493 1 18.4578 15.4507 12.3537 3.87705 -1.0699 -4.92487 -494 2 0.776651 15.5698 12.2511 -12.7177 -2.03387 6.80581 -495 2 18.1456 15.6789 11.4721 -4.67377 -0.406651 0.743757 -496 1 16.5694 4.36967 5.25107 0.98709 -29.8421 42.9348 -497 2 16.7744 3.81151 6.06026 -19.0257 27.4778 -23.1846 -498 2 17.3898 4.32671 4.78168 15.572 7.21618 -21.1326 -499 1 17.788 3.06911 10.7078 7.64381 16.9425 17.2861 -500 2 0.075758 3.1322 11.0257 -14.4921 -2.82201 -9.29777 -501 2 17.6332 2.20749 10.3226 4.29805 -13.9207 -6.70838 -502 1 12.3142 0.064083 10.1758 -16.2036 46.6093 2.93236 -503 2 11.3746 0.384648 10.259 24.7548 -16.9496 1.0795 -504 2 12.8178 0.919304 10.3228 -10.1981 -36.9052 -8.89593 -505 1 10.3666 9.83315 12.2981 10.0643 6.74252 24.9843 -506 2 11.1015 9.85063 12.955 -7.48254 2.69098 -11.3777 -507 2 10.1328 8.91188 12.2898 -1.25875 -17.3524 -2.69444 -508 1 0.463654 2.82678 7.01839 23.1504 30.9543 10.494 -509 2 0.875324 3.58845 7.48211 -15.8261 -9.71426 -11.3384 -510 2 0.770257 2.12665 7.58365 -2.51696 -19.6875 3.88184 -511 1 0.478371 15.2358 6.91004 -5.36214 -57.1351 9.88058 -512 2 0.585298 15.6463 7.75647 2.33624 13.0536 15.0713 -513 2 0.556531 14.2524 7.18353 -2.6234 48.5984 -27.3232 -514 1 16.9534 7.00251 15.3394 -19.8576 7.98442 -8.98385 -515 2 17.6338 7.63543 15.0899 18.202 -5.57661 4.9227 -516 2 17.3093 6.19568 15.7235 12.2576 0.0838452 -6.46227 -517 1 9.0001 12.4151 8.13768 -31.7276 34.3494 27.7642 -518 2 9.37386 11.8218 7.49742 -2.69042 -17.0115 -24.8182 -519 2 8.02402 12.632 8.03373 37.271 -17.4326 -7.14384 -520 1 1.27238 1.95406 3.05803 -14.2139 -9.70678 -17.9319 -521 2 1.26084 2.61511 2.34121 0.72572 -7.36998 11.1944 -522 2 1.89031 2.22344 3.73293 7.71835 10.2015 -2.21509 -523 1 4.13907 15.1156 9.62039 -24.138 8.67184 14.727 -524 2 4.07003 15.1439 8.65747 7.76366 -2.53025 0.663124 -525 2 4.96029 14.7006 9.86457 16.019 -6.11163 -3.79055 -526 1 7.17628 2.17866 14.5671 8.05543 15.8774 -0.750343 -527 2 6.99528 1.68402 13.7698 -4.08254 -5.57585 -6.74919 -528 2 7.62131 2.98432 14.249 -3.31184 -9.11349 9.13274 -529 1 18.6082 14.7131 2.1481 32.1263 -19.3615 -2.59353 -530 2 0.838003 15.1297 2.25966 -2.55576 -5.62694 -3.02712 -531 2 17.988 15.3544 2.42675 -29.4597 23.3621 5.14018 -532 1 9.94138 2.79524 12.9422 18.0301 -20.084 -2.65944 -533 2 9.79404 2.1456 12.2228 -2.72579 10.1868 5.0837 -534 2 9.17835 3.36299 13.0326 -9.76513 7.42125 -6.32672 -535 1 2.80444 8.90955 13.0076 -21.3878 -12.6555 -0.633582 -536 2 3.06361 9.80599 12.872 11.8276 24.8177 -4.92621 -537 2 3.5122 8.48618 13.4775 16.8101 -10.8298 6.5617 -538 1 3.236 8.3574 3.63664 -3.24123 -25.7508 65.6997 -539 2 3.45085 9.0718 3.07326 14.699 31.6407 -15.7982 -540 2 3.47645 8.58669 4.60794 -10.8292 -3.55345 -46.4885 -541 1 5.62853 7.18594 8.51094 13.0444 23.9613 2.26298 -542 2 5.46784 6.31815 8.13889 -4.11832 -12.799 10.1434 -543 2 4.96415 7.47792 9.15047 -6.22666 -11.1251 -0.517113 -544 1 14.8757 1.26039 2.01768 6.89853 7.12439 -27.6668 -545 2 14.9353 2.01952 2.56559 -6.08088 15.4811 28.5729 -546 2 15.2784 1.60993 1.21235 -3.12956 -15.001 -5.59525 -547 1 8.22892 15.2012 0.850139 9.01324 -8.86779 5.43529 -548 2 9.02213 14.9338 1.33488 4.41045 13.1537 -1.08033 -549 2 7.55366 14.6663 1.27665 -10.9347 0.418265 -6.06235 -550 1 15.6387 1.34587 7.23673 -34.4855 -14.424 -6.72803 -551 2 14.9277 0.724731 6.91269 25.2779 16.6902 6.4887 -552 2 15.1173 2.1119 7.53894 8.3028 -0.775331 -5.89355 -553 1 4.90142 13.0959 18.5232 17.5611 -6.682 24.5871 -554 2 5.32755 13.082 0.76977 -9.23128 1.69535 -18.7742 -555 2 5.44764 13.7122 18.0259 4.92611 -3.73779 -6.82361 -556 1 15.3368 8.46948 18.1479 24.407 23.6523 -18.6734 -557 2 15.8061 9.12264 17.5623 -15.0725 -19.5419 9.94084 -558 2 15.3318 8.91689 0.353875 -7.67765 1.6761 7.06822 -559 1 12.0708 3.01842 18.3809 -8.57811 34.9919 -15.9288 -560 2 11.9316 2.65996 0.60646 7.37996 -15.8634 5.79137 -561 2 12.6022 2.47389 17.7995 4.55547 -17.8211 5.72515 -562 1 13.2139 12.6752 5.17768 -11.8856 9.18106 -10.9384 -563 2 13.7464 12.0348 4.69253 2.29692 -7.56952 8.05888 -564 2 13.2564 12.5123 6.11793 11.0077 -2.72782 9.02039 -565 1 6.05443 7.0356 0.031519 0.145276 -19.8641 5.27909 -566 2 5.93935 7.95118 18.5019 2.68887 36.361 -1.99394 -567 2 5.39095 6.86665 0.702638 -10.5375 -11.3291 0.555603 -568 1 17.7528 16.0276 15.0213 -26.9751 8.08167 9.65398 -569 2 16.9476 16.5457 15.105 2.62193 -2.13449 20.9775 -570 2 17.7479 16.0055 14.0813 23.0391 -15.2709 -33.7916 -571 1 13.196 0.994907 16.5363 6.64944 3.5152 15.0268 -572 2 14.1481 0.997912 16.7614 -13.0846 -5.94027 -6.50206 -573 2 12.8833 0.094199 16.7238 3.13951 3.25376 -8.62791 -574 1 11.1253 14.5647 7.20271 12.6179 20.8985 -18.374 -575 2 10.4007 14.3183 7.72981 -32.928 -10.0181 24.5345 -576 2 11.7186 13.8255 7.26943 16.9686 -3.76464 3.70387 -577 1 17.5081 8.62849 2.08107 18.4536 39.9223 21.5452 -578 2 16.6801 8.63471 2.55495 -14.8656 -12.3201 1.9096 -579 2 17.5233 7.88242 1.516 -5.44609 -31.2556 -23.2052 -580 1 12.3547 8.01168 2.02213 3.34817 7.10659 0.607451 -581 2 12.2384 8.8582 1.54611 -2.17098 -11.1853 7.9144 -582 2 11.9739 7.3152 1.48261 -5.38076 0.52639 -15.2068 -583 1 11.8761 14.6165 10.3364 1.47614 -26.5661 -12.796 -584 2 12.1004 13.7873 9.81464 -15.4397 33.1565 21.8304 -585 2 10.8993 14.6888 10.473 20.8283 -4.95583 -12.7008 -586 1 6.89524 7.05211 15.6117 0.948881 6.37495 10.6055 -587 2 7.81004 7.26536 15.3122 -15.6925 -0.985911 8.93516 -588 2 6.66676 7.54167 16.4408 13.3623 -9.35483 -24.2683 -589 1 8.00326 4.73593 13.4743 46.4542 16.9938 22.3473 -590 2 7.23337 4.7302 12.9572 -38.0428 3.58552 -28.1525 -591 2 8.40671 5.62958 13.343 -10.0413 -24.497 3.68285 -592 1 13.4128 12.1818 14.2522 -5.09814 -0.706424 13.2965 -593 2 12.9414 11.3292 14.2657 9.08717 -0.174959 -7.02282 -594 2 13.7875 12.315 13.3696 0.74786 -2.13255 -0.749325 -595 1 14.8395 9.42189 7.30548 -8.6508 -34.4179 -15.7659 -596 2 15.7087 9.765 7.42505 16.3683 18.0856 5.12693 -597 2 14.2269 10.0768 7.57319 -16.6679 19.7312 11.3719 -598 1 12.6526 17.0686 3.07252 -27.098 39.8252 10.9251 -599 2 12.8376 17.5237 3.93373 4.63929 -18.9198 -22.9156 -600 2 11.9913 17.6958 2.63477 30.4514 -31.1971 13.898 -601 1 1.15545 7.13838 17.4647 3.17244 9.59861 -23.4243 -602 2 0.330359 7.36323 17.9184 0.96629 -9.78644 0.159833 -603 2 1.05514 7.47868 16.5422 0.732192 -3.11516 17.9471 -604 1 12.7562 5.15096 15.6457 43.4314 -6.34677 13.892 -605 2 13.4512 4.55662 16.0315 -22.7809 11.2033 -14.7919 -606 2 13.2414 6.00335 15.5788 -11.6166 -6.13865 2.23982 -607 1 2.53993 3.38757 4.97618 -22.6627 40.6834 48.2045 -608 2 1.7609 3.18232 5.58922 26.9518 1.19035 -20.1247 -609 2 2.84154 4.31546 5.27885 -5.90416 -46.089 -11.2441 -610 1 8.33186 11.2983 13.4548 -26.6082 5.68838 43.1719 -611 2 8.4244 11.0562 14.4444 7.75654 0.873515 -50.9507 -612 2 8.91168 10.8786 12.8197 22.3442 -13.0535 12.4472 -613 1 12.8689 1.31514 13.3384 2.90045 58.5941 -12.9641 -614 2 13.42 1.58034 12.5659 -7.54964 -19.9936 10.3698 -615 2 12.4231 2.17844 13.5496 8.73522 -32.0886 -3.11014 -616 1 6.34008 13.7169 2.14963 -18.1698 -8.87317 18.5321 -617 2 5.63978 13.877 2.82959 15.2612 6.49493 -20.3543 -618 2 6.88351 13.0442 2.56282 10.2537 -4.17084 0.110729 -619 1 15.9206 6.61444 12.7992 -24.6515 -28.5257 0.353752 -620 2 16.3106 7.25195 12.2393 18.8127 19.5603 -18.6955 -621 2 16.4213 6.59661 13.608 8.17022 1.84551 14.3752 -622 1 16.8298 0.712824 9.59482 4.92561 -19.6459 1.56363 -623 2 16.8791 18.3713 9.72616 -6.7933 22.7031 -2.37673 -624 2 16.5452 0.8605 8.67269 -3.47063 -2.57745 5.28583 -625 1 6.14624 11.7631 8.37671 0.810232 -55.5778 6.71556 -626 2 5.32447 11.4591 8.84151 13.2611 12.3623 -11.7456 -627 2 6.64226 10.8931 8.20176 -18.8432 36.5086 0.169281 -628 1 2.88754 8.61261 0.453821 16.629 -12.4076 -25.9584 -629 2 2.45212 8.04764 18.3917 -7.9132 30.8844 23.5565 -630 2 2.34875 9.28564 0.895642 -16.9187 -4.58083 -11.1609 -631 1 10.1674 10.4623 6.50123 2.03347 0.962837 -14.0367 -632 2 10.6087 9.69731 6.89122 -0.033473 -1.16532 5.68604 -633 2 10.4694 10.4636 5.56932 -4.02396 0.831062 14.2442 -634 1 6.7142 15.6951 6.55167 21.2433 7.58031 13.0519 -635 2 7.14328 16.1838 7.27089 -7.64643 -7.38759 2.93585 -636 2 7.21237 16.006 5.79102 -10.2318 7.90387 -13.7372 -637 1 6.445 13.1807 5.57797 -4.95716 -23.6388 -1.26087 -638 2 6.7301 13.9465 6.07331 -1.77634 9.04977 6.94523 -639 2 6.09943 12.5433 6.22286 1.34041 6.33507 -0.553394 -640 1 16.8242 12.5629 9.83758 4.06472 -20.7324 4.78658 -641 2 16.9985 11.8651 9.16533 -5.27225 15.8277 3.76725 -642 2 16.5644 13.3844 9.42716 1.03985 5.07871 -11.9 -643 1 6.03738 2.95058 2.86354 -7.03855 -25.5492 -1.19629 -644 2 6.40977 3.757 2.57075 15.9289 34.7492 -4.17594 -645 2 5.57703 2.61747 2.09059 -4.9021 -9.32473 -6.53819 -646 1 10.9114 3.33767 3.30112 5.22699 -4.50477 6.26496 -647 2 10.297 4.02722 3.58926 -1.95634 -6.20434 -4.73409 -648 2 10.5127 2.84524 2.57795 -5.80356 2.60284 -4.41077 -ITEM: TIMESTEP -10 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.68613 7.08001 17.9478 -7.01358 -5.91592 2.73538 -2 2 7.77987 6.83016 18.2266 16.0785 4.58355 -9.56375 -3 2 8.81561 6.77572 17.042 -2.60158 -2.67368 4.89818 -4 1 18.5411 8.25019 6.8397 -3.31911 20.0829 53.2463 -5 2 0.132112 7.95881 5.98338 15.0803 -17.7916 -37.9407 -6 2 0.419079 7.77779 7.52768 -3.57438 0.834533 -17.4022 -7 1 8.38502 18.5543 6.8162 17.8503 9.74549 -0.663478 -8 2 9.33656 0.12202 6.71165 -15.3958 -3.25669 1.14423 -9 2 7.91896 0.595612 6.31609 0.0971505 0.0480551 2.20998 -10 1 6.59239 1.84347 11.7106 33.6248 -3.3918 -11.5419 -11 2 5.88602 2.36507 12.0365 -24.0057 14.4643 13.3031 -12 2 6.19621 1.03555 11.4016 -9.54455 -15.1367 -3.43817 -13 1 7.13469 5.75647 2.33282 -16.0707 1.2807 18.6339 -14 2 6.47472 6.10605 3.02238 22.3175 -2.25238 -34.2201 -15 2 7.09016 6.23688 1.47486 -10.0175 -2.52095 21.7818 -16 1 16.2156 10.1493 16.1334 -27.9935 4.46583 14.8083 -17 2 17.0011 10.2168 15.6173 19.2784 7.57164 -10.1711 -18 2 15.8457 11.0427 16.2776 9.29404 -6.61316 -4.9073 -19 1 10.6069 15.0238 2.30809 -6.31705 -20.7544 -7.43742 -20 2 10.5597 14.4327 3.07214 -0.102442 0.508968 4.74876 -21 2 11.0526 15.7982 2.62807 10.1844 15.1967 6.36644 -22 1 17.1594 8.2489 10.3903 7.52685 0.546464 5.9579 -23 2 16.5819 8.79937 10.9325 -0.0424193 4.91704 3.34034 -24 2 17.9857 8.74574 10.257 -6.36369 -4.03495 0.916497 -25 1 14.8922 15.8683 16.3299 23.5339 -10.8154 7.03311 -26 2 14.0097 16.1903 16.2206 -28.4756 7.26009 1.81472 -27 2 14.9055 15.3621 17.1614 -4.45807 1.9077 -0.883551 -28 1 12.1657 13.3863 0.41518 7.67499 -13.0963 13.9948 -29 2 12.1102 13.7181 18.1579 -7.06431 5.66946 -3.72811 -30 2 11.6673 13.9211 1.04936 -4.85696 8.50836 -7.81927 -31 1 9.27628 5.36844 4.05123 -34.192 4.59602 9.65195 -32 2 8.65917 5.24858 4.84371 24.3198 3.71877 -28.2857 -33 2 8.65376 5.51218 3.29446 11.8948 -3.58803 14.2972 -34 1 1.82985 4.27304 11.6494 -12.5424 24.0017 -6.14821 -35 2 1.72713 5.22025 11.9335 1.67264 -20.3932 -8.37626 -36 2 2.38183 3.84857 12.2925 10.2742 -10.1374 14.5925 -37 1 1.96666 6.8371 8.3675 -1.07206 -9.37897 -7.64517 -38 2 2.48137 7.16021 9.09528 7.6819 14.0614 11.7347 -39 2 1.91994 5.89719 8.57067 -2.65468 -6.85216 -5.3032 -40 1 5.40566 4.39875 7.93795 -15.0212 -10.7202 -17.6012 -41 2 5.47911 3.43644 7.82861 5.00513 7.47325 10.3929 -42 2 4.74947 4.60653 7.2496 8.53973 6.88839 10.8311 -43 1 3.24286 2.9209 17.5475 -3.50993 31.6723 15.8788 -44 2 3.91538 3.33593 16.9792 1.14815 -4.85754 -1.50754 -45 2 2.90196 3.68515 18.1088 4.46159 -27.603 -16.229 -46 1 7.46543 5.27113 6.11173 -0.267366 -14.8618 42.036 -47 2 7.89952 5.61794 6.92737 -2.28349 10.3868 -28.0837 -48 2 7.00366 4.5014 6.50229 0.780861 12.0869 -17.1147 -49 1 9.7753 7.01959 11.9799 12.4421 -0.327694 33.7281 -50 2 10.3285 6.37932 11.5448 5.34489 -7.46932 -11.0014 -51 2 9.14168 7.33293 11.3548 -18.5265 5.10994 -23.2436 -52 1 14.1114 3.54906 8.03925 -21.2079 2.70274 -24.764 -53 2 13.5379 4.24737 7.67406 9.42135 -8.95765 0.532077 -54 2 14.4057 3.90023 8.85862 11.8721 11.0917 26.6467 -55 1 4.80077 17.263 4.02669 -14.2573 4.92943 -10.2324 -56 2 5.55275 17.8868 4.11075 -15.7048 -9.31229 -6.31173 -57 2 4.21849 17.485 3.25536 16.798 3.03083 13.1086 -58 1 16.5008 16.6241 10.052 9.35033 0.377019 -20.0251 -59 2 16.0742 16.3966 10.8515 -13.0635 -0.25069 32.9814 -60 2 15.9476 16.1716 9.40786 2.84148 0.00630379 -7.36632 -61 1 1.95698 4.92664 0.48601 10.6785 6.17321 -0.923017 -62 2 2.54546 5.28332 1.19783 -10.1544 -3.94981 -19.1082 -63 2 1.86706 5.64777 18.4726 -0.259245 -4.73099 10.3692 -64 1 11.8035 13.3621 16.2801 -12.0315 -31.2076 -16.8087 -65 2 11.3006 12.5351 16.4295 -1.37085 13.2186 10.8936 -66 2 12.2283 13.1244 15.4353 5.36339 15.8055 8.10642 -67 1 10.1086 11.0623 16.95 16.2363 -23.6439 1.11167 -68 2 10.572 10.1938 17.105 -14.3776 22.5927 -6.24497 -69 2 9.21542 10.8357 16.6616 -0.160324 -0.0991661 2.29857 -70 1 11.7231 17.5369 13.4667 -11.0418 -25.624 2.08744 -71 2 12.2825 16.9797 12.896 1.06573 10.1819 1.6514 -72 2 12.0497 18.4302 13.3866 8.679 12.3703 -3.21063 -73 1 6.34404 9.31427 12.2267 -10.7289 -25.2447 -16.4149 -74 2 6.95388 8.98312 11.5319 -2.39052 10.1346 10.7157 -75 2 6.76108 10.0063 12.722 17.2241 14.9443 4.4156 -76 1 16.2191 12.7237 2.7003 -6.42998 -13.8373 4.3175 -77 2 16.9936 13.1939 2.44509 26.0904 7.71252 -7.79508 -78 2 15.5637 13.4111 2.72948 -20.2851 11.8065 3.04981 -79 1 0.635855 12.5646 5.86231 -29.6975 10.9384 -12.0161 -80 2 0.906184 12.4779 4.92975 2.15237 -1.21985 12.1118 -81 2 18.3245 12.8391 5.75844 29.6273 -11.2198 7.31028 -82 1 5.19222 16.3868 18.4948 24.5889 -0.529385 -6.85369 -83 2 5.88953 15.8781 18.0466 -13.534 -2.69513 -2.10794 -84 2 5.71609 16.8872 0.480999 -10.5805 4.6302 6.45748 -85 1 0.515864 7.62939 4.0653 41.0474 19.9956 -23.6294 -86 2 18.5677 8.05158 3.40199 9.2753 -7.28591 11.0746 -87 2 1.47269 7.84683 3.73678 -46.4137 -9.00167 19.6367 -88 1 3.14217 8.89553 6.52533 -39.0459 6.50689 -6.5056 -89 2 3.57285 8.63007 7.33767 0.0694837 -1.26665 5.56399 -90 2 2.14756 8.93745 6.67407 38.5311 -3.64433 -0.906695 -91 1 7.31414 10.3036 16.1763 -22.1518 3.21861 21.8391 -92 2 6.53268 10.4772 15.6415 8.43374 -0.0418936 -5.11234 -93 2 6.92709 10.2964 17.0866 13.3044 -2.27208 -10.5118 -94 1 11.1096 1.06093 5.00144 -6.80657 -2.48033 -19.8934 -95 2 11.1672 1.90146 4.5306 6.84499 7.0717 9.43568 -96 2 10.7236 0.515071 4.29558 2.64862 -9.02148 12.7331 -97 1 4.44354 2.70015 13.2121 -7.85281 -5.62302 -11.5877 -98 2 4.59136 3.20795 14.0303 0.103412 -15.4758 0.294405 -99 2 4.3686 1.71349 13.3622 2.85998 26.6352 12.1157 -100 1 8.41457 10.0307 1.78829 1.66015 -12.4273 17.1623 -101 2 8.40835 10.6665 2.53096 -1.47245 -0.417386 -5.09881 -102 2 8.60407 9.1525 2.20287 -3.10051 22.5249 -10.5265 -103 1 10.5229 1.75436 15.5533 -10.8574 -2.31 -4.36647 -104 2 11.4367 1.69676 15.8141 13.1269 -3.82494 7.61076 -105 2 10.5487 1.84704 14.5957 -9.26118 2.80358 -1.94415 -106 1 2.76968 12.9399 7.75003 -7.62511 -10.5749 7.18171 -107 2 3.32023 13.5874 7.29614 -2.30989 2.01815 -3.81018 -108 2 2.03946 12.7099 7.15165 5.79412 3.19458 -2.23462 -109 1 3.64251 11.6901 5.3273 -16.0178 -10.9709 -3.95767 -110 2 3.35804 11.041 6.0007 8.31372 10.277 -11.7948 -111 2 2.86611 11.8409 4.75105 13.6859 -0.281218 5.78901 -112 1 6.88155 14.4797 16.8524 -8.387 2.95998 -0.938339 -113 2 7.57426 13.8507 16.6622 5.60788 -2.76391 3.60002 -114 2 6.54738 14.7428 15.9834 -3.14908 -1.19839 3.78249 -115 1 14.1759 14.5423 3.40785 14.1775 -0.803279 -11.9449 -116 2 13.6583 15.316 3.2037 -5.78511 13.0134 -4.56688 -117 2 13.7723 14.1777 4.18517 -7.95121 -12.1195 11.7606 -118 1 8.26975 18.1784 16.0718 57.0984 -9.85256 5.13508 -119 2 8.90468 17.4721 16.3223 -30.0265 -6.05197 -2.08742 -120 2 8.93252 0.246004 16.0158 -21.102 13.2242 -8.22396 -121 1 4.73201 1.6168 4.90814 8.59128 29.3629 -19.7592 -122 2 3.91099 2.13549 5.04668 12.4977 -9.17326 -4.88478 -123 2 5.26431 2.14928 4.23236 -22.3039 -21.7635 28.9569 -124 1 15.1182 12.8405 16.4381 19.169 -3.61406 36.631 -125 2 14.6612 12.9963 17.2965 -1.87916 -0.605635 -21.6052 -126 2 14.5331 12.7051 15.7087 -30.2626 -2.71441 -16.8094 -127 1 15.786 18.3864 16.793 25.1295 13.8681 33.7963 -128 2 16.4578 18.6099 17.5315 -31.6416 -14.5347 -31.3905 -129 2 15.6162 17.4305 16.8164 1.02724 4.80811 3.46398 -130 1 1.14089 1.13731 16.5539 1.05247 19.7088 19.8175 -131 2 1.92337 1.60495 16.9036 -3.97271 -4.80748 -10.3705 -132 2 0.461096 1.48073 17.164 6.66439 -11.1518 -10.5802 -133 1 18.0862 4.58432 15.8734 11.1688 -12.2484 -2.69667 -134 2 18.5694 3.95442 15.2994 -8.21946 11.4291 8.6944 -135 2 18.5872 4.69164 16.6898 0.203498 -2.64567 -2.95902 -136 1 12.2303 16.9505 16.1288 -38.2728 -13.2591 26.8237 -137 2 11.3888 16.5791 16.5378 36.1694 7.82178 -3.50336 -138 2 11.9114 17.1502 15.2549 6.78701 5.10115 -22.4581 -139 1 15.8814 2.54765 17.9709 5.97775 7.55467 -0.319093 -140 2 15.7733 3.43717 18.3784 -1.8513 -17.3861 -11.5789 -141 2 15.6471 2.5946 17.0126 2.53833 6.86428 19.1803 -142 1 6.70799 13.8021 10.253 -1.58408 1.43394 8.76454 -143 2 6.59288 13.5189 11.1728 1.36627 8.87991 1.27306 -144 2 6.58321 12.9942 9.75946 1.30239 -6.02422 -13.3165 -145 1 10.1413 18.2148 2.80353 9.44086 30.3012 -19.3156 -146 2 10.2266 0.305071 2.14691 0.267733 -14.8877 14.3982 -147 2 9.27777 17.8669 2.60695 -13.096 -6.5965 0.845742 -148 1 2.97176 17.7529 6.06326 -6.30899 -0.645097 35.0899 -149 2 2.08427 17.6133 5.69483 9.57331 2.68214 -12.771 -150 2 3.63239 17.8017 5.37586 1.28926 -2.69105 -18.2517 -151 1 12.5668 16.9974 7.96757 -20.2971 -18.5655 21.3419 -152 2 11.8856 16.2971 7.95074 9.26888 3.31932 -10.856 -153 2 12.3344 17.4798 8.78306 11.437 7.92329 -7.28752 -154 1 14.8861 15.2795 8.28974 -15.7554 0.3814 10.2226 -155 2 14.0374 15.7294 8.25106 -5.80199 2.88483 11.5438 -156 2 15.1981 15.4683 7.42207 26.2963 -2.4275 -26.3232 -157 1 17.5473 18.3112 0.374559 -18.2134 -6.45531 -4.6775 -158 2 18.2634 17.761 0.12213 22.8374 -25.4457 -15.3465 -159 2 17.9951 0.303427 0.894204 5.3706 29.2695 18.8411 -160 1 0.910079 10.3754 1.4141 -19.386 -45.7403 28.0244 -161 2 0.0926857 9.86966 1.69283 27.9138 11.9581 -5.7438 -162 2 0.554372 11.07 0.90565 -10.4877 37.4892 -28.5805 -163 1 1.56425 12.1843 3.32385 10.4497 17.8757 14.7846 -164 2 1.39557 11.5297 2.67534 -6.58566 -33.3087 -13.0061 -165 2 1.62643 12.9551 2.76927 3.66066 18.4363 0.784965 -166 1 0.55148 17.2559 4.87768 14.7947 16.704 -22.83 -167 2 -0.0171494 17.9122 5.24737 -12.9669 22.3753 -0.718336 -168 2 0.416337 16.5086 5.40997 -1.38762 -39.6682 22.4532 -169 1 1.10468 1.00284 9.3945 22.843 10.0615 -6.85845 -170 2 1.39907 0.698807 10.2625 -7.65597 -6.79115 6.92044 -171 2 0.213465 0.701839 9.27091 -15.6194 -8.53979 4.03703 -172 1 16.7947 2.33154 13.2859 2.87858 8.18604 -25.1476 -173 2 17.0129 2.55787 12.3417 -6.42954 -5.0835 25.2497 -174 2 16.4749 1.41822 13.3005 0.0523867 -3.46078 1.59731 -175 1 2.46566 15.827 12.1934 26.7468 -10.5365 13.2985 -176 2 2.93451 15.5288 13.0073 -9.90545 6.65681 -19.023 -177 2 2.95128 15.4495 11.4346 -3.9234 5.36807 1.6728 -178 1 16.4371 15.5461 5.94503 -4.66267 19.6238 -8.97399 -179 2 17.3612 15.5093 6.28134 -9.63254 6.93473 -7.38316 -180 2 16.3109 16.2991 5.29174 10.2179 -16.1602 20.4085 -181 1 5.84392 5.02209 11.7979 1.85982 -4.44524 -6.98506 -182 2 5.51366 5.87933 12.041 -2.35542 15.5447 8.97079 -183 2 5.10963 4.44446 12.0068 -1.26359 -10.5886 0.396425 -184 1 15.2223 4.8645 0.724291 -23.0156 -11.391 23.7803 -185 2 14.7624 4.52384 1.55825 21.1304 12.2284 -22.5635 -186 2 14.5125 5.05103 18.7394 0.751055 2.39009 4.23042 -187 1 16.343 16.2984 2.11648 10.3227 5.9227 -27.7144 -188 2 16.0112 16.8052 2.83865 -11.2354 10.0489 28.078 -189 2 16.6417 17.0002 1.51324 -1.84363 -9.29214 0.277829 -190 1 0.300695 4.8777 3.79796 -11.7144 38.8206 3.66766 -191 2 0.319109 5.88664 3.94702 6.24107 -45.2605 -6.61048 -192 2 1.15751 4.50056 4.01017 2.49534 2.82459 2.96224 -193 1 2.92353 14.9884 15.0405 10.7548 -7.33568 16.7257 -194 2 2.98085 14.609 15.9661 -8.47597 15.0336 -19.5599 -195 2 2.47925 15.8529 15.1074 -0.728265 -0.613609 8.13891 -196 1 1.11951 14.5697 9.5576 17.0302 46.4745 -20.2694 -197 2 2.08903 14.5584 9.38425 -20.4257 -12.3501 8.75388 -198 2 0.805573 13.7616 9.91809 5.52927 -28.6811 10.8766 -199 1 13.6617 16.6633 11.5459 -10.7506 10.3565 -21.4971 -200 2 13.3218 17.4276 11.0158 5.92664 -14.8533 17.3679 -201 2 13.3915 15.8986 11.0154 -3.11899 -0.859159 7.39997 -202 1 4.73366 1.47986 0.719369 -25.3145 -4.02421 3.51446 -203 2 4.15092 1.98399 0.125941 8.58395 1.79335 0.854136 -204 2 4.09918 0.853913 1.13528 12.7275 2.9151 -0.0185569 -205 1 1.42442 18.4742 11.9045 -6.93945 20.4545 -13.991 -206 2 1.2372 0.390371 12.6666 -0.822965 2.19478 3.53324 -207 2 1.89543 17.725 12.2367 7.95706 -17.4489 5.30436 -208 1 11.5469 10.1058 4.11116 26.1716 14.4711 -26.2735 -209 2 11.5284 10.5631 3.21886 -3.69376 -13.1884 23.9867 -210 2 12.5118 10.0773 4.36205 -26.1062 -0.534026 -7.20275 -211 1 8.37237 12.1712 3.75254 -13.3709 24.5961 46.1376 -212 2 9.17249 12.5936 4.11701 3.41223 -8.92861 -19.033 -213 2 7.75234 12.4533 4.48752 5.20668 -18.7884 -32.053 -214 1 14.3233 4.03204 3.29282 11.0049 6.10018 19.4579 -215 2 14.9517 4.19348 4.04461 -8.72763 -4.53117 -18.7735 -216 2 13.4979 4.46304 3.56838 3.12416 -1.49393 -3.31976 -217 1 5.58139 1.77074 7.50691 -36.613 -47.7339 30.604 -218 2 4.96189 1.1025 8.02564 35.7201 38.4984 -27.3817 -219 2 5.38779 1.57566 6.57729 1.13697 3.96791 -6.02851 -220 1 17.9042 1.1171 4.88471 6.84957 17.1887 -7.45832 -221 2 18.4571 1.56865 4.21188 -4.6905 -14.0516 5.22121 -222 2 17.737 1.81424 5.53024 -1.96776 -6.02251 3.4729 -223 1 6.82733 9.39684 4.48845 1.87187 -0.890058 -10.0607 -224 2 6.84716 9.53076 5.42818 -7.08772 5.76802 18.8049 -225 2 7.72364 9.08838 4.32443 4.93667 -1.85919 -9.57362 -226 1 2.70107 14.964 1.9632 9.79064 -8.50271 -23.1477 -227 2 3.33865 14.7342 2.63816 0.0868029 -0.794049 11.9475 -228 2 3.17782 14.7454 1.13419 -13.4 8.87294 12.5953 -229 1 17.2782 12.8964 13.1387 8.1593 -36.3772 6.82198 -230 2 16.3556 13.1177 13.3173 4.03584 18.7537 -2.31465 -231 2 17.8303 13.6552 12.9439 -8.38561 20.0322 -1.78655 -232 1 15.018 10.5797 1.38541 -30.6488 -33.8734 -22.7761 -233 2 15.5405 11.2097 1.82354 25.6355 33.1541 21.1587 -234 2 14.2986 11.0703 0.97193 1.92599 -0.723232 4.24038 -235 1 5.71261 6.94641 4.5266 2.6516 -23.4686 10.5302 -236 2 5.87991 7.88124 4.41392 4.1014 10.4162 -0.896017 -237 2 6.40034 6.62744 5.14459 -6.91809 0.316355 -6.72793 -238 1 8.10894 8.26231 10.1757 -1.61977 4.99166 17.0229 -239 2 8.63366 8.87039 9.65704 12.8257 12.1371 2.09156 -240 2 7.5873 7.82886 9.51802 -16.026 -14.2044 -11.4362 -241 1 13.5265 18.2929 5.80397 -22.7677 -1.43199 15.791 -242 2 12.744 0.210577 5.63003 6.52185 -0.137688 -2.34328 -243 2 13.224 17.7307 6.55929 8.82644 11.7072 -16.2211 -244 1 0.31998 2.55606 0.111337 -23.7151 48.4906 1.53453 -245 2 18.006 2.70756 18.6319 7.21623 -15.3908 0.76394 -246 2 0.639493 3.49242 0.214062 7.71863 -30.3236 1.31164 -247 1 12.6438 10.9651 9.76843 -27.6007 42.776 -15.0826 -248 2 11.6462 10.8587 9.68427 36.5826 -6.8361 3.61513 -249 2 13.0097 10.1328 10.024 -0.792921 -29.0746 6.76076 -250 1 0.78357 12.2825 11.0843 20.7577 -6.91251 -2.74458 -251 2 18.4749 12.2741 11.1385 -12.0685 2.84404 7.0736 -252 2 1.15918 12.6384 11.9096 -11.1326 -3.84191 -3.75479 -253 1 5.04379 7.22322 13.4829 1.39832 5.89977 -6.97466 -254 2 5.58123 7.93479 13.1271 0.448534 7.96016 -10.0051 -255 2 5.53384 7.00565 14.2746 1.03136 -7.66768 11.7435 -256 1 1.27874 6.97532 11.834 -32.074 -43.2189 -14.0481 -257 2 0.482678 7.18669 11.3131 10.1443 0.561183 6.98996 -258 2 1.70367 7.78255 12.0103 18.1825 36.8435 9.31001 -259 1 15.4541 9.47267 12.3132 5.88964 23.7827 6.22024 -260 2 15.5166 10.4677 12.3686 -5.40153 -30.7713 4.20372 -261 2 15.4815 9.07432 13.2056 -1.6395 12.2138 -11.1334 -262 1 16.6425 12.9485 5.45228 -24.7761 13.2233 -32.5849 -263 2 16.3124 13.8685 5.42836 11.1894 -7.98651 20.9726 -264 2 16.4187 12.7313 4.52305 11.1313 -16.3356 15.5726 -265 1 6.1733 10.0557 0.193027 -12.4899 -11.5053 -32.3049 -266 2 5.38495 10.4604 0.58061 6.43577 -0.470902 4.897 -267 2 6.88008 10.1049 0.827544 12.5305 3.42311 14.2724 -268 1 12.3659 6.05415 4.04188 -22.1763 -21.8278 15.5685 -269 2 12.3683 6.79715 3.46108 4.13216 24.0909 -16.7914 -270 2 11.421 5.79287 4.05326 15.4186 -0.211849 3.77561 -271 1 0.132582 12.8231 0.203992 -0.195483 1.63508 -4.90635 -272 2 -0.0245094 13.5503 0.825031 2.49545 -1.98409 0.771993 -273 2 18.2458 13.055 18.0666 5.13636 -1.5464 3.82803 -274 1 3.83888 18.5816 8.61379 -9.81831 -4.88162 -16.6552 -275 2 3.52001 18.2631 7.75085 8.43173 -4.7192 1.01067 -276 2 3.03206 0.305129 8.96677 -7.80256 7.43459 9.99927 -277 1 7.39556 17.2738 4.45596 16.9172 12.0122 12.5371 -278 2 7.99849 17.9848 4.79149 -15.6229 -16.9846 -19.2965 -279 2 7.33818 17.3251 3.48629 6.36463 5.57381 8.87833 -280 1 9.21998 17.0388 12.2284 15.8258 3.83046 11.207 -281 2 9.35195 16.1931 11.7423 2.16771 12.8413 7.7779 -282 2 10.0104 17.2216 12.8137 -16.5375 -11.854 -19.0408 -283 1 13.3184 13.0063 7.94019 -19.3301 -32.807 5.85066 -284 2 13.1883 12.2647 8.56801 -4.60418 3.91603 -7.64254 -285 2 14.1459 13.3708 8.19821 21.3317 21.1541 5.11013 -286 1 14.9844 2.95035 15.3504 8.07249 -1.73557 -24.8008 -287 2 14.3 2.40675 14.9389 -0.805511 -1.63288 7.60525 -288 2 15.6705 2.98762 14.6436 -9.05507 2.69068 16.8604 -289 1 9.85476 15.5033 17.004 5.70996 8.22456 -10.0233 -290 2 10.2769 14.6753 16.7296 0.407564 1.12786 2.5917 -291 2 9.2992 15.3275 17.7693 -4.49302 -4.18434 5.79618 -292 1 11.2887 8.25054 16.5462 4.3815 15.8935 1.4126 -293 2 10.7498 7.72178 15.9677 -11.4268 -3.01506 -11.0903 -294 2 11.7109 7.60541 17.1026 7.03572 -6.39426 11.2088 -295 1 3.78312 18.1923 16.7229 -8.20319 16.8802 -14.09 -296 2 4.23544 17.5706 17.2928 8.99584 -2.65396 14.876 -297 2 3.78517 0.451969 17.0887 5.65759 -16.2586 2.71634 -298 1 2.1977 4.10819 8.95021 24.5715 -13.8141 31.6135 -299 2 3.03624 3.61916 8.82088 -15.7399 12.2693 -11.2697 -300 2 2.14197 4.07166 9.94067 -11.3718 7.67499 -23.2123 -301 1 9.90974 10.3516 9.73776 -22.8793 37.5197 3.40937 -302 2 9.44348 11.1923 9.4561 16.1923 -27.4723 -0.755713 -303 2 9.93951 10.4177 10.7077 4.76489 -7.47333 -8.73237 -304 1 9.73601 0.810068 10.8572 -6.50885 -0.835519 -1.39877 -305 2 9.40585 18.6129 11.1735 2.22486 -11.7661 13.7712 -306 2 9.0915 1.01857 10.1847 -1.93261 14.5334 -11.6688 -307 1 9.19364 15.2092 10.2107 -23.0073 -10.2994 -8.74256 -308 2 8.9841 16.0542 9.76587 1.98806 -14.8547 5.4661 -309 2 8.35152 14.6762 10.1166 22.3916 12.2872 5.93767 -310 1 0.995532 9.29186 10.3281 47.9462 -2.63812 -8.64675 -311 2 1.22741 10.2031 10.5086 -13.3799 15.5027 2.96196 -312 2 1.9063 8.9262 10.1621 -35.7029 0.949407 3.82346 -313 1 16.813 4.88766 8.1932 11.5161 -10.5322 32.9144 -314 2 16.1615 5.34773 8.77307 11.8935 -6.11126 -18.0819 -315 2 17.4051 4.37395 8.80041 -19.6267 13.8505 -17.9411 -316 1 14.6429 14.6942 0.394535 -7.00543 -1.89626 8.24203 -317 2 15.0463 15.2494 1.09531 -2.64327 -9.316 -7.76003 -318 2 13.8679 14.2346 0.794348 15.878 11.3494 -8.58286 -319 1 3.51953 11.0524 9.63262 1.11689 7.20138 -8.56155 -320 2 3.49309 11.4422 10.5196 2.01858 0.130954 -3.30783 -321 2 3.17116 11.7397 9.0203 2.67149 -7.88535 6.47818 -322 1 11.039 10.8616 1.27104 8.39953 16.0658 -8.46941 -323 2 11.1885 11.6907 0.750788 0.782166 -19.893 14.3131 -324 2 10.1072 10.6419 1.14889 -0.773464 -1.49716 1.06219 -325 1 13.2204 7.07184 12.8933 -24.0174 5.01566 -6.09093 -326 2 14.1394 6.83939 12.9167 20.0602 -3.76028 0.39046 -327 2 12.7464 6.22555 12.8749 2.49778 2.97258 -0.29329 -328 1 9.62856 1.88969 0.946546 9.2636 -0.931103 20.1878 -329 2 8.76541 2.02695 0.593353 -22.3319 -0.80038 -4.92587 -330 2 10.1675 1.74594 0.181071 13.2226 0.132969 -11.6901 -331 1 10.5934 13.5316 4.73807 16.1446 0.574492 13.3086 -332 2 11.4317 13.0614 4.94174 -10.7106 3.3069 -14.0299 -333 2 10.5321 14.1207 5.51129 -4.24994 -4.20037 -10.3127 -334 1 14.2715 1.70318 10.8964 -1.77809 5.91235 7.28652 -335 2 15.0728 1.25501 10.5853 5.24738 9.35157 -1.74174 -336 2 14.4034 2.67095 10.8772 7.32957 -6.49183 -2.39775 -337 1 14.6603 12.4192 11.7243 1.91159 -25.2344 -56.6412 -338 2 15.4845 12.4874 11.1931 -4.23005 7.1619 22.5795 -339 2 14.0903 12.0081 11.0211 -1.48986 11.1607 31.5891 -340 1 8.24886 5.08654 9.79134 -29.2123 3.64284 23.7692 -341 2 7.42109 5.02927 10.3149 15.0309 17.1198 -4.03621 -342 2 8.23121 4.21184 9.43797 12.1669 -22.8524 -17.3047 -343 1 1.59528 16.8201 18.3251 -4.66834 32.7155 -7.23976 -344 2 1.93304 17.2062 17.488 -5.12416 -8.69561 13.5025 -345 2 1.82608 15.9028 18.3034 8.21551 -19.1337 -3.40609 -346 1 1.44054 17.2474 15.3375 38.2305 -7.16391 -6.50211 -347 2 1.35107 18.1379 15.6308 4.79859 24.8425 9.12518 -348 2 0.562777 16.9452 15.3387 -39.5261 -18.284 -3.02502 -349 1 3.72855 5.57524 6.20331 -9.94128 10.6794 2.05156 -350 2 3.21297 6.20603 6.76334 9.83918 -6.42931 -13.7589 -351 2 4.29894 6.06824 5.5848 -3.89827 7.08279 4.15512 -352 1 12.3545 9.42683 14.1827 20.4014 -41.9092 8.4814 -353 2 12.8623 8.59837 13.88 -21.4785 35.8512 3.66034 -354 2 12.0611 9.1345 15.077 2.36507 11.6403 -12.9904 -355 1 4.03327 15.2744 6.905 24.5442 3.45717 -5.69457 -356 2 3.46314 16.0225 6.67296 5.01039 2.15408 -3.12402 -357 2 4.97164 15.5268 6.67147 -27.9532 -4.4537 7.17357 -358 1 0.606997 8.56433 14.8637 1.00605 -0.185347 4.59471 -359 2 0.51054 9.52697 15.0006 4.18475 -5.95105 -3.81642 -360 2 1.25745 8.45601 14.1476 -5.10421 5.72757 5.73964 -361 1 12.9756 8.36618 10.3398 20.3701 -17.1189 -10.5242 -362 2 13.727 7.8435 10.0036 -6.14808 8.99881 -11.6124 -363 2 12.9675 8.02293 11.2263 -11.3517 2.56625 21.5008 -364 1 15.2884 7.63693 3.49378 10.1588 18.7913 -12.1111 -365 2 14.5458 7.1482 3.08376 7.93209 -0.245397 21.6039 -366 2 15.5211 7.50792 4.43838 -15.1505 -14.5868 -6.72816 -367 1 17.3202 6.64717 0.0328861 -29.9623 13.6257 -2.83905 -368 2 16.7745 5.97673 0.482414 9.93705 -0.647346 -3.81794 -369 2 16.6178 7.22121 18.2734 18.8696 -9.84661 9.86066 -370 1 8.80495 6.92785 7.84504 -31.0915 -18.6038 9.28479 -371 2 9.6769 7.2872 7.80779 30.3288 7.87046 2.96903 -372 2 8.72406 6.35246 8.64105 6.6093 9.83872 -10.9319 -373 1 12.3211 0.614363 1.17365 13.0662 -3.77868 -0.487657 -374 2 13.0766 0.983141 1.64654 -0.239842 1.32967 3.5541 -375 2 12.751 18.5673 0.657414 -10.2946 0.778432 -2.83622 -376 1 5.67951 15.1028 14.5131 10.9467 16.6442 -3.65569 -377 2 4.71936 15.1727 14.6088 -3.18386 3.297 0.861488 -378 2 6.03308 15.9436 14.1233 -11.409 -15.106 9.73801 -379 1 3.83531 6.52602 1.68735 -5.34791 11.2881 1.09554 -380 2 3.46655 7.33088 1.27913 5.03876 -12.3281 -3.02901 -381 2 3.83759 6.80671 2.60341 5.67562 -6.55284 8.9174 -382 1 3.89065 11.6139 12.2421 9.17745 -10.34 -2.42323 -383 2 4.7546 12.041 12.3761 -4.43478 1.7756 4.32079 -384 2 3.22616 12.1252 12.7041 -4.55935 10.4369 8.15325 -385 1 5.44913 3.8771 15.872 6.89679 52.3696 13.3559 -386 2 6.00532 3.19945 15.5174 15.3476 -19.3003 -7.67953 -387 2 6.04432 4.69577 15.9682 -27.8341 -34.2187 -5.04159 -388 1 14.46 10.319 4.39654 9.99722 -28.3378 -34.0856 -389 2 14.8446 9.82936 5.13517 -3.65574 0.244774 4.37558 -390 2 14.7053 9.78242 3.56924 -11.9433 24.8074 33.8136 -391 1 7.944 17.2975 9.23787 -28.0002 30.4191 -3.50914 -392 2 7.19679 17.6006 9.79194 10.1387 -11.5361 -1.79961 -393 2 7.93806 17.9436 8.50883 9.12371 -8.84918 -0.989999 -394 1 4.50274 14.4265 3.96251 25.8442 16.5744 44.5421 -395 2 4.82189 15.3364 4.24204 -15.9069 -22.6382 -13.9696 -396 2 4.78076 13.8411 4.72747 -13.1976 12.376 -28.3375 -397 1 14.3227 7.38582 15.7589 14.6846 6.74467 9.8564 -398 2 15.2487 7.24382 15.4614 -20.8339 3.06086 7.28672 -399 2 14.432 7.78597 16.648 -5.3607 -7.66211 -14.83 -400 1 2.87305 18.2228 1.9038 16.9424 31.4889 37.3817 -401 2 2.5254 17.6641 1.24513 -20.0746 -27.9737 -30.7942 -402 2 2.12041 18.5329 2.44243 8.04928 -1.15784 -8.26421 -403 1 7.96513 1.6038 4.534 28.375 12.0389 1.8382 -404 2 7.4881 1.94169 3.78174 -16.4915 0.831655 -6.1583 -405 2 8.81315 2.08427 4.47067 -11.0504 -12.9149 7.37414 -406 1 2.66628 14.1304 17.7551 -36.5802 -20.3813 5.76686 -407 2 1.82799 13.6385 18.0009 26.1666 13.51 -7.41699 -408 2 3.38829 13.5766 18.1016 -3.21353 7.84202 -3.40779 -409 1 0.72398 1.68558 13.861 19.6061 1.62564 -3.20216 -410 2 0.832024 1.51571 14.7895 8.81281 -5.19825 13.648 -411 2 18.448 1.87896 13.7961 -22.7247 6.41229 -8.76432 -412 1 4.5528 18.6039 13.9643 16.282 -5.93943 -10.6264 -413 2 5.43228 18.1791 13.8337 -18.6035 11.3559 2.42201 -414 2 4.30609 18.3878 14.8696 -5.35687 -0.29015 4.72759 -415 1 7.10471 0.475722 18.3652 -9.95344 30.3778 33.8159 -416 2 7.09526 0.10374 17.5021 -2.11792 -9.18089 -28.9852 -417 2 6.24907 0.928295 18.5508 11.5399 -12.8337 -6.73806 -418 1 16.1003 18.4419 14.1295 -36.1288 -26.1963 -8.72431 -419 2 15.3858 17.8107 13.8537 25.0074 20.4613 -2.43664 -420 2 15.9155 18.5409 15.0697 10.6475 8.10349 1.05551 -421 1 10.1087 4.51964 16.2872 -49.6317 2.46368 -20.184 -422 2 10.9899 4.47274 16.5903 35.3659 -6.27505 9.52333 -423 2 9.84839 3.65208 15.9265 12.032 5.89647 9.33422 -424 1 15.84 17.9245 4.41355 -16.3771 8.07859 19.8211 -425 2 16.4973 18.6399 4.5293 -6.75294 -6.64677 -2.2152 -426 2 15.0245 18.216 4.92863 29.2279 -12.5546 -21.8691 -427 1 6.93052 17.3604 13.733 43.7573 11.6301 8.94285 -428 2 7.46287 17.7112 14.5144 -20.3873 -12.0805 -21.5216 -429 2 7.61723 17.2481 13.0216 -16.2109 2.19972 16.1164 -430 1 13.284 6.56612 6.73549 -17.3988 -10.9235 -13.9284 -431 2 14.2147 6.66272 6.66556 31.8926 9.42178 10.838 -432 2 13.0817 6.39483 5.81333 -16.4457 -2.73061 -4.18006 -433 1 7.68008 2.38704 9.18412 -10.173 -8.0052 -21.8631 -434 2 7.24249 2.31281 10.0234 -2.88588 -0.126179 20.3224 -435 2 6.98126 2.1061 8.54708 21.029 6.80491 7.05088 -436 1 15.1532 14.8723 13.6487 -17.4978 4.30428 5.82091 -437 2 15.0143 15.0659 14.5909 6.59258 -1.67926 -7.31154 -438 2 14.3234 15.1254 13.2077 14.4343 -4.04757 1.78875 -439 1 9.30028 8.33456 3.70705 10.2977 -8.98362 5.75949 -440 2 10.1463 8.82212 3.80538 -6.03443 -8.47657 3.00821 -441 2 9.47356 7.38745 3.89392 -0.00834887 14.0135 -2.32863 -442 1 17.6906 13.477 16.4461 19.9282 13.2905 -5.82842 -443 2 16.7369 13.3711 16.3792 -1.87427 5.41308 -4.03884 -444 2 17.9311 14.3351 16.016 -12.453 -14.9372 6.18952 -445 1 5.04349 10.6567 2.59903 16.1191 -13.6813 18.2195 -446 2 5.79495 10.2927 3.12129 -13.5181 3.52014 -12.0414 -447 2 4.57705 11.1773 3.24438 -8.0447 10.2459 5.04269 -448 1 3.70971 8.35842 10.3252 1.44092 -18.6834 3.58878 -449 2 3.85247 9.29033 10.1825 3.16815 17.7869 -8.4001 -450 2 3.85129 8.23256 11.2753 -2.11366 -0.888936 -6.9574 -451 1 16.1019 7.11228 6.32302 5.1556 -18.0856 -12.5793 -452 2 16.7603 7.67894 6.76117 -3.13697 -10.0137 -6.06994 -453 2 16.5199 6.22503 6.17941 -9.70023 19.4355 5.8489 -454 1 15.1873 7.00993 9.1119 -0.598311 32.9952 -33.7165 -455 2 16.0219 7.38603 9.44635 -11.3494 -6.74009 0.758637 -456 2 15.0255 7.54922 8.27157 3.37955 -23.1281 33.9738 -457 1 6.44391 13.1496 12.9059 -4.52757 0.45998 7.29234 -458 2 7.24313 12.6736 13.1625 -0.99472 -4.48021 -2.73775 -459 2 6.29798 13.7908 13.6311 -2.25413 -7.45453 -16.6836 -460 1 12.1229 4.49714 13.069 31.9377 20.6864 19.2416 -461 2 12.2438 4.59516 14.0263 7.18846 6.47209 -3.71556 -462 2 11.355 3.98337 13.0276 -40.2556 -25.9573 -14.351 -463 1 11.341 8.18871 7.85243 -8.78275 4.89867 3.16356 -464 2 12.019 7.65272 7.40248 3.56578 3.50389 11.6767 -465 2 11.6495 8.4222 8.75253 4.0122 -9.00416 -11.7002 -466 1 17.1801 10.777 7.4192 7.36201 -8.80257 6.42916 -467 2 17.8272 10.0453 7.20283 -14.4353 25.3005 -3.23105 -468 2 17.1099 11.4706 6.73084 6.53972 -12.3853 -1.04707 -469 1 5.23123 18.1422 11.0533 -19.2518 -11.1169 -0.556795 -470 2 4.68428 18.0818 11.8689 9.03658 -0.237539 -15.4649 -471 2 4.66385 17.8138 10.3113 13.0077 11.3369 14.9543 -472 1 7.56693 17.6215 1.82415 1.62007 -3.46367 5.28784 -473 2 7.78898 16.8334 1.34681 6.63524 -26.0188 -1.32905 -474 2 7.45125 18.2129 1.09256 -3.64481 20.3372 -5.96154 -475 1 1.86389 12.9287 13.6093 11.2123 10.389 11.461 -476 2 1.60858 12.3493 14.3514 0.368407 5.87334 -8.62616 -477 2 2.19533 13.7617 14.0254 -8.04715 -19.4049 -4.74077 -478 1 9.73211 6.79545 14.8053 -13.3635 29.1677 -1.2594 -479 2 9.95388 5.9401 15.1198 6.74212 -35.5267 16.6171 -480 2 9.99758 6.80472 13.8879 2.87601 5.55808 -10.3757 -481 1 15.2079 4.3816 10.7747 2.87683 -10.6846 -6.34453 -482 2 16.1141 4.09829 10.8354 14.0041 -14.4682 -8.99775 -483 2 15.2413 5.10857 11.3759 -13.982 19.572 13.657 -484 1 11.1943 6.12299 0.161942 7.30858 3.38886 3.78771 -485 2 11.3169 5.17116 0.363074 -11.79 12.5462 -9.55941 -486 2 10.2709 6.35961 18.5708 8.1781 -12.6509 6.67443 -487 1 0.185288 11.3311 15.1365 -30.887 25.32 -22.6423 -488 2 18.3259 11.8316 14.411 15.9364 -20.9841 19.9458 -489 2 18.5436 11.8171 15.9275 6.31494 -1.3813 -2.75882 -490 1 7.07253 9.14554 7.26503 -12.8693 -9.44748 7.54332 -491 2 6.53496 8.39024 7.60511 8.01051 18.2562 -7.56901 -492 2 7.96025 8.78683 7.22728 5.66006 -0.214789 -0.295522 -493 1 18.4466 15.4455 12.3524 0.715601 -5.5542 4.25712 -494 2 0.765537 15.5739 12.2932 -9.35503 -1.07101 -3.81958 -495 2 18.1041 15.6865 11.4834 1.82716 1.84183 -0.0676895 -496 1 16.5728 4.36435 5.2485 -25.4993 -8.29978 29.4912 -497 2 16.6816 3.92322 6.14286 5.98391 16.1522 -30.7717 -498 2 17.375 4.39451 4.72672 17.8313 -3.46111 1.89189 -499 1 17.7791 3.0704 10.7152 16.7916 7.15275 7.98838 -500 2 0.0816242 3.14072 10.966 -13.8603 5.05813 -1.71981 -501 2 17.7027 2.20602 10.3066 -7.17166 -8.4112 -5.21368 -502 1 12.3075 0.0618611 10.1685 -8.15907 17.9474 -0.312818 -503 2 11.3684 0.344551 10.3468 27.9971 -1.27027 -0.956139 -504 2 12.8942 0.865557 10.2681 -22.4015 -23.39 -3.54403 -505 1 10.3613 9.82386 12.3172 12.1455 12.129 19.7304 -506 2 11.1427 9.8808 12.9129 -10.2174 -2.53791 -7.09814 -507 2 10.1997 8.88396 12.252 -0.966331 -12.4705 -0.927319 -508 1 0.481536 2.83002 7.02126 3.70324 23.8076 -10.0458 -509 2 0.770856 3.62826 7.51109 -3.83076 -19.2444 -0.666321 -510 2 0.694466 2.06428 7.55035 5.7415 -3.83046 10.8422 -511 1 0.467049 15.2425 6.91705 -4.45928 -38.0226 -11.2702 -512 2 0.600151 15.6263 7.78281 2.30728 -6.41275 13.0317 -513 2 0.61271 14.2361 7.00049 -2.84554 47.7716 -5.16909 -514 1 16.9541 7.01237 15.3291 23.6374 -7.48971 -3.1828 -515 2 17.7457 7.53254 15.1705 -1.99719 18.034 -6.10418 -516 2 17.38 6.19105 15.5941 -13.3003 -10.4743 0.120416 -517 1 9.01017 12.4224 8.1441 -46.2717 9.6088 -11.1501 -518 2 9.26268 11.8248 7.45061 25.2615 -14.9445 -10.6927 -519 2 8.05034 12.5239 7.91838 26.5695 6.53823 20.3475 -520 1 1.26455 1.94093 3.05316 3.58571 9.71968 -12.011 -521 2 1.22461 2.59742 2.34045 -8.12686 -11.986 1.71554 -522 2 1.93366 2.31359 3.63129 0.35358 -2.72116 4.87465 -523 1 4.13309 15.1146 9.63821 -4.623 1.46382 -0.938733 -524 2 4.12694 15.148 8.67475 -7.89004 5.45838 -0.100118 -525 2 4.98588 14.7259 9.81048 11.3537 -4.87926 10.963 -526 1 7.17766 2.17952 14.5652 7.62536 9.73749 11.0593 -527 2 6.96972 1.69872 13.7643 -0.327528 -0.451328 -7.35604 -528 2 7.66158 2.98182 14.3072 -3.86315 -8.18785 -0.50787 -529 1 18.6094 14.7115 2.1553 18.1066 -29.4746 -3.14947 -530 2 0.852094 15.108 2.23259 -6.38197 3.09186 -0.259441 -531 2 17.9366 15.3527 2.32074 -15.2526 23.2774 3.26778 -532 1 9.94663 2.7868 12.9455 2.69617 -13.1789 -11.1834 -533 2 9.77369 2.19316 12.1903 7.43131 1.21406 6.14773 -534 2 9.20096 3.38667 12.9408 -6.30409 9.38042 4.37845 -535 1 2.80852 8.91644 13.0153 -16.8956 -9.28674 -0.0207487 -536 2 3.13809 9.78934 12.8448 9.36486 20.7895 -4.33486 -537 2 3.52774 8.43066 13.407 13.2058 -10.3846 6.75792 -538 1 3.23128 8.35577 3.63883 6.10249 8.71431 60.2633 -539 2 3.54401 9.08838 3.13137 7.96401 15.5303 -21.3649 -540 2 3.46232 8.64756 4.58519 -13.4978 -19.9669 -35.5279 -541 1 5.63324 7.19832 8.5125 -13.133 -10.0414 6.96154 -542 2 5.51092 6.25688 8.34615 12.8941 -5.44374 -4.51219 -543 2 4.92213 7.36133 9.14092 2.83191 13.4678 4.26874 -544 1 14.878 1.27944 2.0109 -7.35803 -30.2596 -13.1701 -545 2 14.8616 1.98275 2.64555 4.54601 24.3613 2.83628 -546 2 15.264 1.50064 1.14913 0.22226 12.7122 6.62367 -547 1 8.2353 15.1956 0.84899 9.2054 13.6294 -15.3468 -548 2 9.04355 15.0937 1.38227 -7.5254 -5.87742 4.76726 -549 2 7.50355 14.6763 1.20804 4.58246 -4.32042 7.88142 -550 1 15.6328 1.34461 7.23795 -19.9173 -11.1245 -9.46976 -551 2 14.9591 0.718796 6.85982 16.5955 19.1651 8.9454 -552 2 15.1508 2.16575 7.45752 1.02199 -7.71962 -3.30529 -553 1 4.91374 13.0908 18.526 15.2565 -4.60213 14.3208 -554 2 5.33439 13.1154 0.77269 -6.07604 1.59812 -16.6926 -555 2 5.51105 13.5936 17.9543 2.83588 -2.74206 0.160853 -556 1 15.3493 8.4742 18.1502 12.1518 9.73195 -18.1744 -557 2 15.7592 9.1135 17.5088 -10.0207 -13.011 16.7995 -558 2 15.2243 8.95162 0.336167 -0.033387 6.18709 -0.40176 -559 1 12.0721 3.03363 18.372 7.89134 -10.3745 2.1206 -560 2 12.0185 2.56449 0.551271 -8.88822 8.03447 17.3967 -561 2 12.5632 2.36483 17.898 4.02516 4.57474 -24.0136 -562 1 13.2076 12.6757 5.17908 4.47921 -5.37266 1.03993 -563 2 13.7293 11.9632 4.79272 -2.12471 -1.88137 -7.76598 -564 2 13.3867 12.5644 6.11349 -3.52883 8.17381 9.78336 -565 1 6.04737 7.04753 0.0353989 10.049 -23.447 -5.31085 -566 2 6.01346 7.99319 18.6275 -7.37118 27.2698 7.20756 -567 2 5.32085 6.74358 0.593628 -6.10646 3.40609 1.47388 -568 1 17.7373 16.0235 15.0083 12.9173 -11.5355 46.7271 -569 2 16.9426 16.5159 15.2406 -3.68569 -0.0523083 -17.9381 -570 2 17.9142 15.8937 14.0864 -12.7219 4.58342 -31.2732 -571 1 13.1912 1.0014 16.5506 10.6966 -14.1722 10.2872 -572 2 14.1553 0.911674 16.6931 -11.9901 3.10273 -3.01829 -573 2 12.8874 0.074803 16.5753 -2.30324 8.04411 -4.14072 -574 1 11.1133 14.5665 7.20897 13.0955 23.3619 -16.6223 -575 2 10.3963 14.2935 7.74934 -21.4591 -15.3449 18.7975 -576 2 11.8402 13.9563 7.34501 4.8973 -5.05394 6.63835 -577 1 17.5096 8.63113 2.08657 0.966478 12.3426 12.6691 -578 2 16.6632 8.50317 2.50987 -10.5053 2.55961 10.3047 -579 2 17.5113 7.91267 1.47949 7.23292 -21.4893 -25.4513 -580 1 12.353 7.99884 2.01581 -2.70101 10.6364 -12.6504 -581 2 12.1945 8.88312 1.63494 1.68617 -6.44935 12.5501 -582 2 11.9639 7.41552 1.35659 -1.58766 -9.18843 -2.08326 -583 1 11.8879 14.6194 10.3406 -20.0746 -33.6598 -22.8547 -584 2 12.0361 13.784 9.8263 4.17148 28.2224 18.5196 -585 2 10.9018 14.6878 10.3309 21.6541 8.7111 3.83339 -586 1 6.88836 7.04362 15.6058 16.1194 20.5136 16.4981 -587 2 7.8035 7.27617 15.3369 -14.4637 -10.2261 -3.41305 -588 2 6.75267 7.59066 16.4113 -4.12685 -13.7627 -18.0291 -589 1 8.00073 4.72844 13.473 32.6072 13.4681 12.0072 -590 2 7.24466 4.78195 12.9199 -26.1194 -0.34176 -19.7698 -591 2 8.43099 5.60279 13.3668 -6.56701 -17.694 4.3215 -592 1 13.409 12.181 14.2619 -2.29334 -12.519 -3.59046 -593 2 13.0674 11.2691 14.1939 2.47622 3.528 5.79283 -594 2 13.8091 12.3245 13.3914 2.14013 7.29019 1.49174 -595 1 14.8335 9.42126 7.30208 -1.23415 -9.7028 -7.755 -596 2 15.6553 9.87909 7.43544 15.0677 5.06613 0.278043 -597 2 14.1895 10.0298 7.62302 -19.0881 6.3544 7.09879 -598 1 12.6523 17.0615 3.07749 -9.63712 20.8437 4.73829 -599 2 12.9489 17.4748 3.92954 -9.59054 -7.90452 -22.4084 -600 2 12.0211 17.6908 2.6147 24.5964 -20.1603 22.3384 -601 1 1.16316 7.14216 17.4575 -7.53687 9.98877 -12.7143 -602 2 0.304551 7.18474 17.9202 3.89796 -5.88799 -6.19513 -603 2 1.03245 7.53978 16.5617 1.30151 -5.77621 16.2427 -604 1 12.7701 5.15004 15.6505 19.6392 -10.8067 9.95473 -605 2 13.4563 4.50157 15.9538 -13.2351 19.2956 -11.0391 -606 2 13.2014 6.03319 15.6187 -0.0564141 -13.897 1.41482 -607 1 2.5292 3.39223 4.98971 -11.294 24.8894 43.5462 -608 2 1.79321 3.13497 5.63732 25.431 9.26734 -19.6171 -609 2 2.95221 4.24201 5.36402 -18.0427 -37.3772 -14.0443 -610 1 8.3195 11.2975 13.4498 34.4282 -42.0873 60.0692 -611 2 8.53145 10.9623 14.3727 -32.5783 27.093 -24.5589 -612 2 9.06913 10.8398 13.0623 -1.46455 6.72769 -32.5395 -613 1 12.8789 1.33599 13.3369 -0.326833 21.0111 -2.4484 -614 2 13.4114 1.42549 12.5087 -12.3149 4.19021 14.3531 -615 2 12.3728 2.16885 13.5095 17.1543 -18.8215 -15.124 -616 1 6.3438 13.6989 2.14861 -9.76603 2.4566 0.239062 -617 2 5.66699 13.9965 2.80165 17.5467 -9.19207 -8.6938 -618 2 6.94024 13.0708 2.57673 -0.273551 -0.649347 7.27334 -619 1 15.9211 6.60722 12.7931 -16.6599 -18.553 -4.38331 -620 2 16.3967 7.19214 12.2261 12.0088 12.5524 -15.4249 -621 2 16.3823 6.6241 13.6257 5.92705 1.19016 14.7721 -622 1 16.8355 0.712467 9.59592 -3.36362 -23.3789 -3.56206 -623 2 16.7779 18.376 9.75078 1.74957 20.9638 -0.413143 -624 2 16.4581 0.840534 8.70411 1.17104 2.38037 5.50581 -625 1 6.14488 11.7511 8.38011 -0.18946 -41.167 -3.37934 -626 2 5.27459 11.5011 8.78729 18.3987 2.85732 -10.3128 -627 2 6.60987 10.8879 8.11154 -22.1828 30.5528 10.1053 -628 1 2.89693 8.62105 0.44295 -56.4203 1.00956 -31.5069 -629 2 2.27197 8.22062 18.4324 34.822 -7.67477 5.45833 -630 2 2.23776 9.23156 0.789096 17.398 15.3469 20.296 -631 1 10.1637 10.4615 6.50349 -4.04384 3.34709 -8.13679 -632 2 10.5967 9.72069 6.94847 1.64295 -0.870339 0.249421 -633 2 10.4974 10.4621 5.5852 -1.057 -0.999308 12.8758 -634 1 6.73224 15.6973 6.55436 -2.09809 -5.48823 4.73835 -635 2 7.11043 16.1412 7.33204 2.41282 1.16671 -8.98558 -636 2 7.01002 16.1566 5.74315 2.18916 7.51026 7.17736 -637 1 6.44608 13.1679 5.58195 -4.20705 -14.9444 9.79279 -638 2 6.65412 13.9682 6.06813 3.08652 7.67851 0.170606 -639 2 6.07667 12.5708 6.24938 0.761343 1.39557 -4.00611 -640 1 16.8208 12.5604 9.84104 -2.42329 -13.6856 -22.0974 -641 2 16.9708 11.9197 9.11347 0.32984 0.887075 14.5477 -642 2 16.637 13.3652 9.35916 0.987515 11.3295 4.43609 -643 1 6.04174 2.95051 2.84722 -0.719082 -29.0389 17.5165 -644 2 6.39757 3.79665 2.63265 6.28437 26.7212 -14.5644 -645 2 5.5959 2.56013 2.08759 -0.264068 2.45464 -11.4985 -646 1 10.912 3.32579 3.30021 -11.54 -3.72468 -0.286686 -647 2 10.265 3.99241 3.57025 6.99069 0.708994 3.18227 -648 2 10.4899 2.90229 2.54711 3.22659 -3.75767 -5.68185 -ITEM: TIMESTEP -20 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.70913 7.06604 17.9499 1.08039 -7.3052 -10.6944 -2 2 7.76309 6.93671 18.0927 2.86377 -0.0634365 6.14939 -3 2 8.89082 6.62218 17.113 -0.435012 1.17195 3.96762 -4 1 18.5701 8.27154 6.84569 7.63886 -4.25596 16.0618 -5 2 0.0770478 8.01704 5.94511 2.80666 -2.10014 -27.175 -6 2 0.448594 7.6266 7.34851 -2.05713 5.96795 6.45131 -7 1 8.39922 18.5714 6.82203 6.72948 10.2859 -1.45868 -8 2 9.32775 0.155905 6.65662 -6.00666 -1.87083 0.283604 -9 2 7.88802 0.6421 6.41318 2.19693 -3.22314 0.641978 -10 1 6.59462 1.83749 11.6886 4.57701 1.91935 4.50468 -11 2 5.92153 2.26167 12.2253 -5.29818 6.79114 -2.36061 -12 2 6.2022 0.990271 11.4833 -4.39091 -13.1588 -5.35683 -13 1 7.12455 5.7334 2.35273 -30.6289 32.8622 11.4294 -14 2 6.61502 6.28908 3.00258 14.1285 -25.9969 -7.59408 -15 2 6.93422 6.24286 1.54682 10.1555 -14.3812 -3.81516 -16 1 16.2065 10.1646 16.1262 8.40668 11.1152 -6.07805 -17 2 17.0895 10.2474 15.7446 -2.7739 -5.15617 3.84543 -18 2 15.9438 11.0841 16.2665 -7.12418 -3.1551 3.11568 -19 1 10.6155 14.9936 2.32061 -1.92123 -0.42827 -4.10202 -20 2 10.587 14.5409 3.17342 -1.90113 -4.17135 2.45193 -21 2 11.1106 15.7965 2.49753 3.42935 4.58062 3.08668 -22 1 17.1538 8.25609 10.4362 5.05968 0.945942 4.2849 -23 2 16.7065 8.97876 10.9029 -1.41924 -5.56537 3.25582 -24 2 18.0123 8.61559 10.168 -2.45464 0.72557 0.389593 -25 1 14.8661 15.8683 16.3562 3.75833 -10.1031 -0.407994 -26 2 13.9609 16.1531 16.2809 -17.2441 8.84265 -1.93831 -27 2 14.8525 15.2671 17.1114 5.79928 3.60638 8.20478 -28 1 12.159 13.3907 0.439783 -6.21112 9.36015 -5.49833 -29 2 12.0312 13.5738 18.1447 5.07318 -6.56614 -2.93527 -30 2 11.6434 14.08 0.875998 -3.18612 -5.19303 11.2101 -31 1 9.2695 5.40921 4.0396 -15.9764 -20.2303 6.13461 -32 2 8.8083 5.02157 4.82949 8.30048 18.0685 -17.5094 -33 2 8.61456 5.30675 3.30783 11.5288 9.4755 11.0493 -34 1 1.82939 4.25621 11.6493 -6.71206 2.38393 -0.709376 -35 2 1.74358 5.20905 11.8686 0.595776 -11.527 -1.23597 -36 2 2.30823 3.82152 12.3665 0.967745 0.8605 0.134832 -37 1 1.98223 6.83069 8.36497 -5.35455 0.0641687 -19.1444 -38 2 2.41924 7.2303 9.11786 5.68758 -2.51321 7.89524 -39 2 2.03012 5.87061 8.47368 0.241822 -0.370612 9.81388 -40 1 5.39801 4.40718 7.93771 10.9733 2.82986 12.12 -41 2 5.47637 3.44759 8.05616 -6.09239 2.90192 -10.948 -42 2 4.7514 4.61131 7.25273 -1.49389 -3.85519 0.176314 -43 1 3.26825 2.92232 17.539 -14.9988 14.8633 6.4114 -44 2 3.91862 3.43305 17.0175 -2.74895 -4.28964 2.11315 -45 2 2.69145 3.57031 18.023 20.6758 -7.505 -11.8237 -46 1 7.47034 5.2735 6.10589 -2.49502 5.37071 -3.04547 -47 2 7.84271 5.98269 6.68437 -5.78386 -20.7203 -0.884416 -48 2 6.94663 4.6123 6.60405 7.6241 17.9385 5.03136 -49 1 9.77266 7.01281 11.9821 10.4665 -1.38292 10.7277 -50 2 10.3585 6.42202 11.517 6.59042 -6.6592 -2.49871 -51 2 9.12807 7.25863 11.3259 -16.7919 6.8996 -8.63143 -52 1 14.096 3.56038 8.06303 -5.03459 -1.11151 -11.1946 -53 2 13.7156 4.24767 7.5046 0.899669 0.845681 1.92473 -54 2 14.4812 4.01512 8.80943 2.7486 3.89851 9.64387 -55 1 4.73966 17.2567 4.00996 -0.195125 14.326 -18.5317 -56 2 5.55163 17.7707 4.1353 -4.1295 -8.09403 5.71009 -57 2 4.38972 17.5915 3.15482 -7.00181 -7.87351 15.3992 -58 1 16.5025 16.6092 10.0733 13.1432 9.20378 8.07617 -59 2 15.9712 16.6856 10.8668 -9.96451 -5.5735 1.54085 -60 2 15.9848 16.1464 9.41138 -7.70063 -5.20479 -0.44901 -61 1 1.97052 4.91045 0.450899 1.06366 9.69844 4.9192 -62 2 2.61093 5.33981 1.06219 -5.49885 -10.5105 -8.09306 -63 2 1.57388 5.6737 18.6422 7.70456 -7.85061 -0.972244 -64 1 11.7662 13.3441 16.2815 -7.88535 5.38496 10.7421 -65 2 11.2704 12.5109 16.442 6.50023 4.10664 -10.6094 -66 2 12.3479 13.2575 15.5066 -9.92493 -12.14 1.82083 -67 1 10.1201 11.0576 16.9389 3.39974 -19.6625 0.923124 -68 2 10.5319 10.1651 17.0061 -5.17122 15.3709 -2.15755 -69 2 9.17725 10.8754 16.8052 5.13113 2.71984 -2.06215 -70 1 11.7111 17.5152 13.4588 11.325 -2.75861 -1.19784 -71 2 12.3718 17.1152 12.8813 -0.632983 -4.36671 1.26506 -72 2 11.9961 18.4406 13.4806 -4.40298 2.90056 2.38202 -73 1 6.35795 9.30394 12.2283 8.95317 6.42027 -9.35456 -74 2 6.91663 9.09838 11.465 -5.59359 -11.5346 -0.139091 -75 2 6.8458 10.0391 12.6013 -0.320164 5.49925 11.3434 -76 1 16.2195 12.7457 2.69542 0.295574 -29.3957 1.13627 -77 2 17.0216 13.1501 2.38091 9.97003 13.3951 -1.47132 -78 2 15.5842 13.4209 2.91145 -9.8096 20.1499 -2.69183 -79 1 0.634077 12.5728 5.88372 -7.9484 2.86768 -4.89493 -80 2 0.988616 12.3569 5.00851 -6.1101 5.76055 1.83916 -81 2 18.334 12.7959 5.71409 15.811 -6.64636 4.43625 -82 1 5.2077 16.407 18.4749 -9.68849 -0.552221 -6.28119 -83 2 5.84718 15.7794 18.0984 2.41425 5.32286 5.94338 -84 2 5.56586 16.8292 0.618687 8.26881 -4.78153 -1.34873 -85 1 0.531249 7.63213 4.08542 33.6963 23.9515 -16.2824 -86 2 18.6021 7.94352 3.35108 5.75308 0.311196 11.7347 -87 2 1.44781 8.03396 3.8909 -38.1012 -20.2476 4.98268 -88 1 3.13519 8.90219 6.5128 -18.1806 -1.10975 19.7922 -89 2 3.61721 8.66647 7.3217 -0.167991 0.711605 -10.7948 -90 2 2.18954 8.88363 6.78472 17.5501 0.713198 -9.35234 -91 1 7.30642 10.3086 16.1993 0.33826 1.86993 11.5423 -92 2 6.5825 10.5097 15.5962 -1.40069 -1.74837 7.12047 -93 2 6.94436 10.2588 17.1142 -3.68695 0.804433 -15.344 -94 1 11.1033 1.05136 4.99998 6.51415 -6.68887 15.4104 -95 2 11.3804 1.86173 4.55399 -8.93638 -1.72916 -9.27788 -96 2 10.7652 0.40817 4.35737 0.804793 8.53975 -5.36269 -97 1 4.41906 2.71829 13.1993 1.75265 -17.8891 31.6776 -98 2 4.61925 3.15892 14.0364 2.0928 12.2335 -7.50334 -99 2 4.34595 1.79439 13.5397 -3.31279 7.49147 -22.0731 -100 1 8.39429 10.0534 1.8011 7.989 6.96853 5.58503 -101 2 8.43083 10.7556 2.48299 -4.47719 -6.35615 -3.34103 -102 2 8.76263 9.25633 2.22388 -6.49712 6.95404 -2.63041 -103 1 10.5097 1.74962 15.5619 -18.3761 -0.922722 7.55335 -104 2 11.4225 1.47346 15.6803 4.80494 4.8298 -6.32182 -105 2 10.3374 2.00269 14.6445 6.81104 -1.01801 -3.49857 -106 1 2.7507 12.9226 7.76103 -0.99391 -3.54814 -5.35437 -107 2 3.2837 13.6196 7.35675 1.026 0.47841 4.16479 -108 2 2.1823 12.6261 7.03948 -5.64928 1.37633 4.69044 -109 1 3.65655 11.6901 5.29539 -1.74666 1.04695 -5.47464 -110 2 3.42979 10.9863 5.91968 -0.390133 2.11749 -7.53732 -111 2 2.90341 11.8434 4.69867 6.59799 -3.91283 3.78854 -112 1 6.86195 14.4839 16.8677 -6.59977 -5.37582 9.26387 -113 2 7.63594 13.9204 16.7929 -0.0312736 1.63672 -3.94334 -114 2 6.43125 14.5303 16.0039 6.73415 3.59122 -3.18668 -115 1 14.1795 14.5536 3.39757 15.4782 -5.44823 -10.5 -116 2 13.7027 15.3725 3.25557 -8.02005 3.41109 -0.200737 -117 2 13.6761 13.9828 3.97966 -5.46722 0.130817 9.75683 -118 1 8.30625 18.1704 16.0558 -18.3501 -5.93921 0.16691 -119 2 8.73243 17.3486 16.3757 13.662 16.7968 -4.53324 -120 2 8.86048 0.311637 15.8745 11.2379 -14.2941 4.19403 -121 1 4.7262 1.6175 4.92485 1.6266 19.4211 -17.3379 -122 2 3.85517 2.05812 4.84475 13.0303 -7.24689 7.72044 -123 2 5.31448 2.15314 4.34837 -14.7695 -11.1634 6.67198 -124 1 15.0789 12.7964 16.4332 -6.30353 8.33681 17.3183 -125 2 14.5699 13.1854 17.1557 10.6035 -4.81202 8.18161 -126 2 14.431 12.7912 15.7403 -5.45963 -10.7064 -24.7799 -127 1 15.7876 18.4014 16.8102 7.97993 -1.6905 34.0366 -128 2 16.3475 18.509 17.631 -13.1355 2.97046 -27.3317 -129 2 15.4303 17.5059 16.9211 5.07282 4.66478 -9.26997 -130 1 1.15379 1.15776 16.5585 8.66192 -1.89028 -5.04545 -131 2 1.90132 1.75074 16.7615 -7.4852 -3.92147 5.78546 -132 2 0.484053 1.2881 17.242 6.61018 5.41271 -0.381602 -133 1 18.0958 4.56873 15.8951 8.25715 -8.22974 -2.59939 -134 2 18.5403 4.03662 15.2192 -4.31028 2.25805 3.56674 -135 2 18.6753 4.5681 16.6654 -3.11748 0.528024 -3.18079 -136 1 12.2229 16.9717 16.1366 4.99185 -14.9968 15.1993 -137 2 11.5697 16.3784 16.5746 6.13992 18.0067 -10.7689 -138 2 12.0903 16.9196 15.1862 -11.661 1.79059 -6.40221 -139 1 15.9175 2.52925 17.9868 -5.04918 24.4496 -1.91719 -140 2 15.7053 3.35036 18.4645 1.43445 -9.55155 0.206063 -141 2 15.6037 2.74854 17.0829 8.19816 -13.208 8.21894 -142 1 6.7035 13.812 10.2396 3.19471 14.7437 0.534165 -143 2 6.61208 13.6203 11.1841 -1.85117 -10.3739 -2.65392 -144 2 6.65674 12.9942 9.7292 -2.15383 -4.24588 3.01674 -145 1 10.13 18.2471 2.79005 6.2323 7.4499 -7.90816 -146 2 10.2641 0.289717 2.1086 -4.88175 -4.44055 6.63338 -147 2 9.27512 17.8471 2.59242 -0.00557908 4.28296 0.85488 -148 1 2.97726 17.7544 6.09154 9.3411 -8.798 -12.7807 -149 2 2.21419 17.6669 5.51339 -17.57 2.09099 8.77855 -150 2 3.67394 17.6484 5.43984 9.00485 8.25893 -0.00709571 -151 1 12.565 16.9537 7.99058 7.14198 1.79921 -4.31208 -152 2 11.8238 16.3251 7.88339 1.67036 10.005 4.65414 -153 2 12.3624 17.6704 8.62526 -6.57036 -14.6618 3.16709 -154 1 14.8823 15.2807 8.26789 -1.91265 -14.526 28.7428 -155 2 14.153 15.9118 8.23916 -2.47753 6.09246 -10.9919 -156 2 15.4304 15.3156 7.48892 0.613021 10.1448 -23.5664 -157 1 17.5919 18.2849 0.376053 -34.2379 -2.64943 -3.08159 -158 2 18.3697 17.8673 0.0312256 25.6277 -7.0964 -1.13253 -159 2 17.798 0.454484 0.829223 12.3697 7.05842 3.85092 -160 1 0.890355 10.3869 1.40531 11.5261 -26.8893 18.421 -161 2 0.106732 9.81739 1.52594 3.68606 12.403 0.666184 -162 2 0.670163 11.0869 0.811123 -14.943 21.2909 -16.3167 -163 1 1.59243 12.2061 3.32787 10.8868 -1.98125 32.4665 -164 2 1.41581 11.4302 2.79423 -4.35317 -0.696655 -17.6875 -165 2 1.68603 12.9921 2.7891 -2.29445 2.46974 -13.9165 -166 1 0.556424 17.2525 4.88159 28.516 -3.31441 -27.2608 -167 2 -0.112492 17.9263 4.93691 -11.7284 7.93843 13.1539 -168 2 0.513874 16.5834 5.55808 -11.2757 -6.6263 16.6148 -169 1 1.11617 0.979823 9.41029 -8.01472 5.90786 -6.49609 -170 2 1.17088 0.754182 10.3385 12.3333 -8.44182 10.8127 -171 2 0.193916 0.78552 9.22994 -1.98368 -3.92324 -6.63209 -172 1 16.7786 2.33534 13.2836 0.301257 -1.02782 -8.61363 -173 2 16.9098 2.55877 12.34 -0.551981 -1.96326 12.3514 -174 2 16.5533 1.39033 13.3371 -1.81134 4.54396 -2.66642 -175 1 2.50838 15.8231 12.1881 11.0759 -0.61625 -4.91684 -176 2 3.05623 15.4799 12.9137 -5.11001 1.87196 -7.11666 -177 2 2.97562 15.6336 11.349 -1.75425 -0.738878 7.05871 -178 1 16.4241 15.5762 5.95419 20.8818 34.7414 3.73321 -179 2 17.3417 15.6388 6.29893 -10.1511 -9.39035 -1.02331 -180 2 16.3256 16.4387 5.46724 -6.92566 -23.7939 4.29358 -181 1 5.82318 5.04015 11.787 7.38202 -1.28642 -1.97288 -182 2 5.53279 5.76584 12.3478 -8.19426 6.74642 1.34004 -183 2 5.25308 4.28957 11.9879 -3.19521 -0.0404241 -0.10221 -184 1 15.2058 4.86095 0.714988 -15.0911 -0.578133 32.6943 -185 2 15.0554 4.65905 1.68214 1.80466 1.09263 -27.7183 -186 2 14.3514 5.22673 19.0716 10.184 -3.76227 -2.57358 -187 1 16.3414 16.3313 2.1188 1.69452 -20.4231 -15.1031 -188 2 15.9696 16.7397 2.89766 0.772445 11.9995 9.83785 -189 2 16.487 17.0139 1.46036 1.64169 8.90638 2.00624 -190 1 0.27953 4.87193 3.80304 22.0083 21.7264 1.42732 -191 2 0.488965 5.84197 3.75834 -13.581 -23.7134 5.51739 -192 2 1.12962 4.47493 4.05501 -10.8528 -1.93786 -0.672788 -193 1 2.93644 15.0118 15.0505 -0.31189 -6.67479 38.4938 -194 2 2.77152 14.5973 15.941 9.17422 6.49202 -18.5047 -195 2 2.6087 15.9081 15.2082 -8.55577 3.59906 -10.383 -196 1 1.11893 14.5977 9.54871 15.5404 -15.1461 3.70851 -197 2 2.05973 14.499 9.39244 4.56619 15.8955 -5.72674 -198 2 0.980037 13.7309 9.94382 -18.1835 3.0763 3.0761 -199 1 13.6623 16.6444 11.5318 -24.61 2.13122 1.95847 -200 2 13.1623 17.4223 11.2076 12.7863 -8.68657 -5.97173 -201 2 13.1098 15.8918 11.2458 9.29846 2.29742 -4.43006 -202 1 4.71401 1.48013 0.724257 -0.188744 -1.90188 8.47653 -203 2 4.10877 2.04213 0.209428 1.54459 -7.39683 1.44825 -204 2 4.1847 0.878426 1.28084 -4.13807 4.124 -10.8706 -205 1 1.4317 18.499 11.8861 -0.747589 2.74228 -9.05649 -206 2 1.26248 0.376362 12.6752 -1.22453 3.10674 7.57799 -207 2 1.76508 17.6414 12.1696 1.67944 -1.01146 1.59049 -208 1 11.5426 10.114 4.08871 14.5973 5.39555 -25.8673 -209 2 11.3947 10.5181 3.18641 4.0612 -8.18021 22.6028 -210 2 12.5241 10.0302 4.19261 -20.6338 4.9276 -1.52234 -211 1 8.35442 12.1679 3.75067 -15.8416 -4.27069 -7.38356 -212 2 9.18656 12.6319 3.95442 -10.6107 -0.215004 12.2135 -213 2 7.67679 12.3128 4.45645 22.0699 3.83678 -6.48541 -214 1 14.3334 4.02625 3.28975 21.4077 6.9275 8.44763 -215 2 15.0849 4.22802 3.89908 -16.2072 -5.96795 -3.3621 -216 2 13.5509 4.49592 3.62574 4.82101 -0.669553 -3.42678 -217 1 5.57933 1.73516 7.50739 -24.0378 -31.7376 11.0088 -218 2 4.91074 1.07012 7.91595 32.7583 31.1537 -18.2093 -219 2 5.45045 1.65908 6.53973 -4.97377 0.997246 11.1506 -220 1 17.8945 1.1186 4.8831 -1.36037 -2.43827 -6.93143 -221 2 18.5804 1.42855 4.26031 -6.60553 2.78724 7.64102 -222 2 17.8025 1.76232 5.59874 4.87877 0.216211 -3.29328 -223 1 6.83024 9.40422 4.48506 -14.9488 0.581331 -12.2421 -224 2 6.75886 9.5424 5.43046 9.61942 2.86103 10.3107 -225 2 7.75214 9.21615 4.27366 4.86133 -4.03573 4.34319 -226 1 2.68867 14.9529 1.96243 -3.68441 -0.0776758 1.15821 -227 2 3.24659 14.6776 2.70632 3.58292 1.9147 -7.42106 -228 2 3.21497 14.9558 1.15083 1.81588 -2.88288 8.16929 -229 1 17.2949 12.8929 13.1574 -7.5849 14.4302 -4.04848 -230 2 16.4401 13.3055 13.2858 -13.783 -13.5119 9.83474 -231 2 17.7157 13.6748 12.8001 24.9453 0.592093 -1.55303 -232 1 15.0095 10.5719 1.38917 -11.2702 -15.2105 -5.46509 -233 2 15.5687 11.2426 1.76309 11.9887 12.322 8.95719 -234 2 14.2298 11.0424 1.10476 -6.47688 3.25886 -0.810136 -235 1 5.70264 6.91192 4.53101 4.96234 -7.94583 8.40724 -236 2 5.98573 7.83684 4.52277 1.36545 -0.678753 -1.4492 -237 2 6.33051 6.43499 5.10591 -2.47306 1.6182 -5.79546 -238 1 8.0801 8.26782 10.1943 -2.48094 -3.5573 30.8197 -239 2 8.76371 8.85191 9.85613 0.308879 9.43682 -13.0265 -240 2 7.56027 7.88877 9.48994 -2.62488 -0.283604 -15.3664 -241 1 13.5 18.3149 5.7974 -5.02979 10.2931 3.81039 -242 2 12.85 0.37996 5.63415 -2.0272 -10.2183 1.79381 -243 2 13.182 17.8392 6.59435 1.6098 2.02728 -12.9685 -244 1 0.276709 2.57627 0.11216 -0.0492842 3.76989 10.2262 -245 2 17.9528 2.7291 18.6895 13.0336 8.33648 -1.41355 -246 2 0.811706 3.36861 0.368499 -21.4808 -7.42382 -6.02819 -247 1 12.6714 10.9997 9.76016 -23.5437 -7.71308 -4.31472 -248 2 11.7133 10.8659 9.59681 15.3229 11.3368 0.532821 -249 2 12.914 10.0869 9.9422 13.3726 -3.72203 6.47581 -250 1 0.779958 12.2601 11.0819 -4.3547 -6.1438 5.62044 -251 2 18.4678 12.2984 11.1653 -6.51403 -1.20026 -7.70008 -252 2 1.07438 12.4529 11.9792 8.34734 4.57522 -3.24255 -253 1 5.0586 7.24501 13.467 -14.0099 -7.28532 -8.10759 -254 2 5.49528 8.03405 13.1289 12.6282 1.90126 -2.15469 -255 2 5.51501 6.98287 14.2704 7.34444 5.85192 6.7727 -256 1 1.26105 6.94281 11.8301 -2.26861 -4.26975 2.97 -257 2 0.502637 7.2894 11.3564 -2.98104 -0.152382 -1.57853 -258 2 1.67901 7.71469 12.2201 5.00338 4.10874 -3.32488 -259 1 15.4732 9.48624 12.3091 -7.90575 31.4836 20.4854 -260 2 15.2888 10.4503 12.3878 3.68649 -17.5592 -11.9783 -261 2 15.3484 9.17907 13.2194 3.56004 -6.14635 -9.9625 -262 1 16.6235 12.9071 5.45115 4.22183 -17.5767 13.0612 -263 2 16.4576 13.8585 5.58703 -5.89626 -6.38642 -16.4082 -264 2 16.4453 12.6107 4.54016 -1.61972 14.741 3.30454 -265 1 6.17978 10.0207 0.140312 6.69901 -0.902574 1.02107 -266 2 5.53175 10.4562 0.704359 -7.04498 -0.0752206 -3.29626 -267 2 6.99223 10.1412 0.643131 5.59964 -6.49227 2.85612 -268 1 12.3558 6.06094 4.04059 -1.82306 -10.4932 18.2897 -269 2 12.2948 6.89378 3.5711 -3.30175 6.87328 -14.7087 -270 2 11.4523 5.72881 4.15047 2.03572 4.51633 -5.92335 -271 1 0.151611 12.8143 0.201399 6.45324 -5.46068 -3.81056 -272 2 -0.0140355 13.4798 0.883392 3.4035 3.37155 -1.9342 -273 2 18.3672 13.1447 18.0414 -1.87626 -1.08321 2.97259 -274 1 3.81145 18.5877 8.5912 1.31461 -3.73146 5.16785 -275 2 3.56882 18.0432 7.82418 -6.49798 6.54364 1.53441 -276 2 2.99788 0.372962 8.89657 -5.11276 -3.31294 -4.1744 -277 1 7.4281 17.2705 4.47377 6.46179 23.4452 -11.2721 -278 2 7.96797 18.0618 4.61565 -3.66399 -5.46425 9.5792 -279 2 7.28703 17.3462 3.52078 -0.310988 -11.8901 2.26571 -280 1 9.22893 17.063 12.2466 22.6161 -18.3078 -0.374418 -281 2 9.25634 16.2959 11.6379 -2.98004 10.6911 5.23864 -282 2 10.0783 16.9759 12.7442 -18.2994 12.1316 -6.13803 -283 1 13.3197 12.9538 7.95187 -9.96581 2.72298 -9.05352 -284 2 13.2593 12.2563 8.62517 4.24613 3.77329 1.00191 -285 2 13.899 13.6706 8.22561 11.1032 -0.425478 9.75376 -286 1 14.9719 2.96045 15.3396 1.81329 0.120121 -0.870248 -287 2 14.3995 2.21229 15.1018 3.59949 7.50345 -3.65154 -288 2 15.6901 3.005 14.6772 -10.8991 -3.85704 4.22675 -289 1 9.85324 15.5257 17.0014 3.97317 -4.57748 -3.47476 -290 2 10.3864 14.7538 16.7592 -3.54516 -0.814303 -2.23392 -291 2 9.2485 15.2429 17.6987 -0.194096 3.36496 6.55889 -292 1 11.2976 8.26736 16.5426 7.06128 19.5884 6.19806 -293 2 10.6048 7.82655 16.0501 -2.15009 -7.46249 -5.1526 -294 2 11.6506 7.64084 17.1804 -3.23764 -5.26669 1.48715 -295 1 3.80261 18.1891 16.7286 5.96532 3.63646 9.58286 -296 2 4.2558 17.5705 17.3068 2.57751 -13.4277 -2.28373 -297 2 3.88923 0.356458 17.2317 -6.08372 7.81341 -6.39572 -298 1 2.19516 4.11859 8.94937 -6.46461 1.56382 -5.27436 -299 2 3.07192 3.77694 8.7043 -7.24867 0.753394 12.5906 -300 2 2.01364 3.98399 9.90559 16.1239 2.6739 -11.0998 -301 1 9.88488 10.3605 9.72172 5.12637 14.4569 -2.91242 -302 2 9.60959 11.2332 9.33432 -0.0101703 -19.6763 14.6837 -303 2 10.1282 10.4603 10.6632 -8.0115 2.48909 -7.97128 -304 1 9.71465 0.804575 10.8512 21.7431 15.3431 10.1505 -305 2 9.2832 18.6897 11.2643 -8.53487 -4.69507 -4.97966 -306 2 9.18676 1.22081 10.1628 -13.1132 -5.80645 -3.94121 -307 1 9.20675 15.1716 10.2106 -23.935 -1.88548 4.57185 -308 2 8.85892 15.9372 9.71979 2.38257 -5.68301 1.50138 -309 2 8.39577 14.638 10.4071 17.7258 6.53325 -11.5344 -310 1 1.0072 9.34307 10.3251 -13.5607 -2.30165 -2.87521 -311 2 1.0259 10.3094 10.4263 12.3488 -1.76633 0.307332 -312 2 1.88127 8.96784 10.1532 -1.03643 13.7416 3.72628 -313 1 16.8438 4.87108 8.18901 -4.78961 0.896955 11.5039 -314 2 16.1406 5.46499 8.54396 15.0863 -10.4307 -3.41532 -315 2 17.2081 4.33923 8.92353 -6.78534 8.8584 -10.8667 -316 1 14.6587 14.7041 0.366828 1.30507 -0.478814 3.63059 -317 2 15.185 15.0332 1.12636 -7.04307 -0.464202 -11.0373 -318 2 13.8385 14.3426 0.742198 8.82268 0.591631 -2.33039 -319 1 3.54036 11.0513 9.61487 2.50715 2.61524 -7.45538 -320 2 3.63629 11.5626 10.435 -2.71976 -6.10697 -0.243655 -321 2 3.06413 11.634 8.99273 6.16009 -0.263385 5.30284 -322 1 11.0628 10.8412 1.29387 1.94664 2.31063 1.36488 -323 2 11.3352 11.6508 0.816723 -4.4237 -7.82009 8.11802 -324 2 10.1138 10.7005 1.1254 8.25661 2.0034 -0.662671 -325 1 13.2071 7.092 12.8743 -8.181 6.96481 -7.78695 -326 2 14.1492 6.89693 12.9368 4.59729 -0.0390769 -2.26511 -327 2 12.7747 6.23567 12.7699 0.0352738 -4.27477 4.68983 -328 1 9.62872 1.89049 0.957357 1.17656 -1.16236 13.2501 -329 2 8.73134 1.77169 0.632677 -1.73422 -2.0126 -6.33446 -330 2 10.2301 1.88378 0.211292 -0.739962 2.15457 -7.7161 -331 1 10.5914 13.525 4.7165 6.94092 6.03141 -14.7136 -332 2 11.5001 13.1966 4.5902 -6.55933 -2.4681 12.9436 -333 2 10.616 14.067 5.5206 3.43098 -5.16043 -1.25188 -334 1 14.3018 1.72484 10.9172 13.4371 11.1223 -9.93713 -335 2 15.1272 1.43467 10.5035 -1.81024 -10.6133 4.43081 -336 2 14.4134 2.68551 10.8564 -6.433 0.422524 6.62217 -337 1 14.6521 12.3877 11.7022 -8.45049 -6.71538 5.80805 -338 2 15.5103 12.5052 11.2413 -17.7577 -5.57988 -7.54306 -339 2 13.9188 12.0751 11.1197 22.5147 4.82958 0.534535 -340 1 8.2427 5.06906 9.80652 6.55588 21.6544 3.19941 -341 2 7.41824 5.23391 10.2944 2.41744 -11.9303 -3.89737 -342 2 8.21758 4.20856 9.37923 -10.585 -10.7296 4.55255 -343 1 1.58459 16.8369 18.3321 1.96955 3.78018 0.59611 -344 2 1.85004 17.2184 17.4898 0.0469727 3.49377 1.52109 -345 2 1.98826 15.9645 18.3052 -5.87072 -8.1408 0.0386171 -346 1 1.45085 17.2397 15.3384 19.3024 -11.6024 -7.75777 -347 2 1.52928 18.1033 15.7334 -7.82156 13.9033 4.46915 -348 2 0.523156 17.01 15.2404 -5.15812 1.64021 5.22009 -349 1 3.71432 5.60797 6.16821 -6.42766 23.1509 5.2389 -350 2 3.10788 6.20238 6.65309 4.74203 -10.8724 -0.844938 -351 2 4.31902 6.23597 5.73943 -0.58891 -7.80382 -7.69424 -352 1 12.3617 9.44178 14.1897 14.768 -21.5294 -7.13739 -353 2 12.6854 8.60646 13.7318 -7.61852 23.4532 21.1317 -354 2 12.1886 9.19254 15.1239 0.0190459 -2.13671 -14.4759 -355 1 4.02789 15.2847 6.90037 19.6963 3.91174 -8.53909 -356 2 3.59813 16.0446 6.4807 -5.57314 -2.58109 7.58101 -357 2 4.98627 15.4174 6.72455 -14.0806 -2.64155 5.91133 -358 1 0.604694 8.56382 14.8836 6.38519 14.8729 2.46932 -359 2 0.593576 9.52815 15.0331 -4.38489 -7.16014 1.99766 -360 2 1.21683 8.48632 14.1406 0.0450847 -3.26888 3.80333 -361 1 12.9907 8.33553 10.3435 -10.7244 11.0212 -25.595 -362 2 13.7217 7.85043 9.92864 1.48882 -4.14748 10.5805 -363 2 12.916 8.06476 11.2563 9.06532 -10.0671 12.5191 -364 1 15.3021 7.67479 3.50456 -15.706 -31.6797 19.6454 -365 2 14.5991 7.08356 3.22123 -2.84665 13.9574 -20.9494 -366 2 15.4859 7.21773 4.34079 18.8178 22.1978 3.49889 -367 1 17.3057 6.66581 0.0439089 -0.566439 -0.157214 -4.14934 -368 2 16.9415 5.80914 0.322205 -4.36129 9.908 -1.962 -369 2 16.5386 7.21525 18.4101 8.51434 -8.37768 3.91558 -370 1 8.82219 6.93132 7.84612 -10.1525 -9.67927 6.48857 -371 2 9.74438 7.17539 7.82243 13.4851 9.91198 -3.74634 -372 2 8.75511 6.31699 8.60098 -3.86074 2.18846 -4.69843 -373 1 12.3417 0.621389 1.18077 -6.9564 -3.41972 6.83906 -374 2 13.1525 0.726993 1.70017 3.48999 0.0677543 -9.59522 -375 2 12.4857 18.5505 0.551479 3.63823 3.88808 0.842467 -376 1 5.6677 15.1168 14.5202 -2.89809 14.409 3.62726 -377 2 4.73779 15.2069 14.7798 -2.10515 -4.92641 -4.42493 -378 2 5.95698 16.02 14.2745 1.37709 -12.0745 -2.57764 -379 1 3.85174 6.50812 1.71549 -1.87326 -9.92841 -7.94113 -380 2 3.40118 7.27684 1.32447 4.40945 3.56133 7.79633 -381 2 3.98293 6.6854 2.65555 -2.72837 5.07562 -0.486349 -382 1 3.88774 11.6179 12.2731 7.36248 2.53406 3.74193 -383 2 4.74563 11.9961 12.5096 3.21135 -1.44769 -3.24982 -384 2 3.26188 12.2215 12.6852 -7.1456 -2.35069 3.20446 -385 1 5.4326 3.86602 15.8669 5.46195 27.5847 5.5501 -386 2 6.12196 3.19729 15.7751 -0.292732 -1.96119 -5.07149 -387 2 5.89955 4.7414 15.9262 -11.6823 -23.746 -2.53289 -388 1 14.4519 10.31 4.40466 -0.198609 -22.4452 -14.1251 -389 2 14.647 9.76314 5.18938 0.972168 3.21729 -6.37484 -390 2 14.6939 9.77999 3.59617 -3.45576 13.8176 24.0335 -391 1 7.91012 17.3396 9.21881 -3.47249 -5.09989 3.31179 -392 2 7.12992 17.5549 9.76562 5.48476 5.05439 -11.164 -393 2 8.00718 17.9294 8.44912 -7.46491 1.16212 7.11091 -394 1 4.51961 14.4455 3.97665 1.46094 13.6517 19.4367 -395 2 4.57851 15.3966 4.28178 1.46521 -27.5553 -6.05216 -396 2 4.65578 13.8277 4.74009 -3.41874 17.0045 -15.0106 -397 1 14.2914 7.39173 15.7568 2.67151 4.01398 13.8033 -398 2 15.2382 7.26829 15.5879 -5.04223 1.8615 0.0507223 -399 2 14.2621 7.71182 16.6758 1.37252 -0.910778 -10.0112 -400 1 2.89282 18.2219 1.89623 16.0954 20.7868 19.4211 -401 2 2.43498 17.5738 1.38145 -10.8581 -14.0242 -17.961 -402 2 2.20473 18.7378 2.33948 1.00824 -0.59586 0.163903 -403 1 7.97772 1.60288 4.53639 1.7563 -9.68985 13.008 -404 2 7.31922 2.029 3.97737 7.04095 6.46018 -8.6135 -405 2 8.84264 2.02013 4.43356 -4.53303 1.60821 -5.92451 -406 1 2.59943 14.1332 17.7414 -8.95394 -18.2677 -2.38171 -407 2 1.94944 13.4122 17.9464 12.5244 20.6844 1.19004 -408 2 3.47205 13.7759 17.9983 -8.8914 0.728457 0.900702 -409 1 0.745112 1.69912 13.8711 11.2473 3.52367 -11.146 -410 2 0.914419 1.4049 14.7673 -7.77297 1.70239 6.88788 -411 2 18.4589 1.93825 13.7842 -0.334419 -0.897106 4.15254 -412 1 4.53599 18.6175 13.9535 -3.4557 6.59794 -4.70782 -413 2 5.46815 18.3485 13.9788 -8.18255 -2.00556 -1.03369 -414 2 4.11637 18.3402 14.7801 5.6735 0.958275 2.99437 -415 1 7.096 0.531319 18.3551 -0.694611 7.4496 8.80978 -416 2 7.23097 0.178113 17.4735 2.95576 -3.96306 -6.42653 -417 2 6.14085 0.633472 18.4745 3.33236 6.58102 0.363951 -418 1 16.0915 18.4336 14.0959 0.427379 -0.396215 -8.58483 -419 2 15.3508 17.8946 13.7703 3.59427 8.97013 10.1541 -420 2 15.9721 18.7209 15.0186 -4.35198 -12.8399 -3.85995 -421 1 10.0849 4.5187 16.2702 4.73223 -5.50586 5.92697 -422 2 10.9866 4.63155 16.5807 5.77761 8.19399 -3.69287 -423 2 10.0461 3.5611 16.1717 -6.80252 -1.66686 -4.51665 -424 1 15.8725 17.8845 4.41654 -12.5209 12.7326 5.37596 -425 2 16.3916 18.7124 4.49019 -1.68969 -11.5252 -1.94643 -426 2 14.9593 18.1341 4.67479 17.449 -5.50076 1.40971 -427 1 6.95668 17.3709 13.7302 27.0332 5.97859 23.7699 -428 2 7.35597 17.5596 14.624 -6.60353 0.436933 -26.7426 -429 2 7.73328 17.3113 13.1176 -17.9234 -0.691624 11.5164 -430 1 13.2886 6.54141 6.708 -19.4099 -8.32294 21.4331 -431 2 14.1944 6.83212 6.62317 10.4169 5.52785 -11.9279 -432 2 12.8902 6.38702 5.85009 7.8467 0.777822 -14.5162 -433 1 7.70655 2.38278 9.20977 12.6343 0.60353 -10.8933 -434 2 7.2325 2.23152 10.0347 -6.87682 0.627979 2.4454 -435 2 7.14224 2.1131 8.46352 -1.96859 -1.38987 10.9664 -436 1 15.1599 14.8609 13.6555 2.14917 -2.72077 3.1958 -437 2 15.0894 15.1454 14.5818 -4.10533 -0.470809 -6.08849 -438 2 14.3857 15.1548 13.1581 4.50097 1.9243 4.2209 -439 1 9.31836 8.32368 3.71602 18.5592 -2.51714 11.5674 -440 2 10.1335 8.79007 3.99631 -8.14035 -3.14117 -4.90658 -441 2 9.4898 7.3827 3.90713 -7.2783 5.8685 -3.93333 -442 1 17.7186 13.4905 16.4359 -1.51289 22.2408 -13.156 -443 2 16.7625 13.3639 16.3649 1.62841 -7.26982 3.16217 -444 2 17.8329 14.3608 15.9953 4.68582 -10.1291 6.26608 -445 1 5.02763 10.6563 2.64305 -2.13744 -9.22816 3.31541 -446 2 5.67739 10.1782 3.18798 -3.0773 8.85482 -0.1212 -447 2 4.59818 11.3042 3.21285 3.70326 -1.5106 2.19329 -448 1 3.72149 8.34459 10.2919 -0.179455 -7.68631 -12.7595 -449 2 3.82782 9.26393 10.0171 0.460185 9.10653 3.72446 -450 2 3.7984 8.31763 11.2506 0.24707 1.5831 -0.943414 -451 1 16.0782 7.09232 6.27704 3.78536 -20.3998 -1.61032 -452 2 16.8668 7.5306 6.63092 -6.12864 4.03671 -1.53431 -453 2 16.2929 6.14181 6.32149 -2.48234 12.3559 -4.92911 -454 1 15.1572 7.02511 9.10581 3.8117 16.1939 -22.7388 -455 2 15.9823 7.33517 9.52567 -10.9007 1.4123 -2.48218 -456 2 15.0452 7.59247 8.29613 6.45133 -12.7204 22.5185 -457 1 6.42341 13.1088 12.8743 -8.95622 -6.97199 -8.56847 -458 2 7.13157 12.5608 13.2501 0.579484 9.04377 -2.95583 -459 2 6.27581 13.8943 13.4207 1.62934 -6.42573 5.92996 -460 1 12.1251 4.48872 13.0852 20.6978 11.8008 -11.4801 -461 2 12.1861 4.63134 14.0408 -7.38726 -2.06828 2.45652 -462 2 11.3124 4.06154 12.8314 -12.072 -7.43803 9.29181 -463 1 11.3394 8.19587 7.85205 11.1059 -10.4301 17.8484 -464 2 12.0348 7.61277 7.52234 0.357557 0.521252 -13.0071 -465 2 11.6101 8.269 8.78041 -6.91702 7.4869 -1.95681 -466 1 17.1867 10.7889 7.4395 14.5297 -2.81026 -23.5185 -467 2 17.9096 10.1869 7.16109 -12.9834 1.71839 15.1597 -468 2 17.0415 11.3048 6.62611 -4.1729 8.16775 12.482 -469 1 5.24074 18.1281 11.0581 -15.2173 -3.98599 -8.34189 -470 2 4.58924 18.0057 11.7782 10.2636 1.95052 -8.13419 -471 2 4.73144 18.0737 10.2167 7.33147 4.07832 13.9505 -472 1 7.57528 17.5815 1.8237 -4.07192 12.6902 15.9513 -473 2 7.93668 16.805 1.40258 -2.93669 -7.99436 -16.24 -474 2 7.56667 18.3008 1.17772 -1.22407 -7.09592 -6.98677 -475 1 1.89335 12.9293 13.6081 -2.83392 -4.38044 7.70492 -476 2 1.42634 12.2947 14.1785 7.13969 5.03303 -2.73416 -477 2 2.14611 13.6729 14.1857 -2.01709 -2.63559 -9.61881 -478 1 9.71667 6.79197 14.8165 -19.737 27.0922 8.68981 -479 2 9.89359 5.91802 15.1417 7.60675 -24.7177 2.15595 -480 2 10.032 6.8882 13.9194 5.10262 -3.22926 -9.37061 -481 1 15.2334 4.35765 10.7756 -27.5978 -16.2477 -22.3588 -482 2 16.1684 4.22394 10.6591 16.9939 1.30069 13.5789 -483 2 15.041 5.04225 11.4098 10.4595 11.1452 11.1309 -484 1 11.214 6.13659 0.181715 -19.0514 -14.6776 -12.5318 -485 2 11.2124 5.17659 0.0304417 14.0569 6.29109 5.62342 -486 2 10.2823 6.34718 18.6411 6.7491 10.3457 6.1137 -487 1 0.148583 11.3373 15.1258 -19.5821 15.0001 -24.2151 -488 2 18.1981 11.6758 14.382 16.6378 -5.64999 24.2973 -489 2 18.7581 12.0391 15.8029 -7.9684 -6.15355 -5.02438 -490 1 7.07881 9.17505 7.27008 -6.43803 -1.74166 -4.58486 -491 2 6.45798 8.45812 7.48524 7.10939 3.15379 4.24177 -492 2 7.95401 8.76045 7.26417 -3.66954 2.28396 2.09633 -493 1 18.4168 15.4276 12.3546 -3.43386 -0.549873 -4.48624 -494 2 0.729474 15.5504 12.2627 0.527014 -4.05801 2.94094 -495 2 18.0745 15.7474 11.5108 -2.98934 0.409485 0.218187 -496 1 16.554 4.36499 5.23729 20.8954 -6.05263 25.9175 -497 2 16.7683 4.14077 6.16822 -16.8827 1.59137 -12.628 -498 2 17.4495 4.42836 4.87212 -5.6372 6.04853 -15.3532 -499 1 17.7678 3.07292 10.7257 -2.33819 12.1961 -2.64827 -500 2 0.05876 3.27172 10.9273 -5.50289 -7.01135 -0.383438 -501 2 17.6798 2.21428 10.2822 5.02163 -0.151153 2.81987 -502 1 12.2925 0.0394171 10.1485 -5.03026 26.5344 11.6637 -503 2 11.4572 0.407352 10.526 9.87088 -12.259 -12.5756 -504 2 12.9102 0.803778 10.1803 -6.63246 -15.2789 0.0865208 -505 1 10.3587 9.80679 12.3603 15.6128 10.3756 0.750657 -506 2 11.1656 9.89562 12.9016 -9.14674 -1.49827 1.04164 -507 2 10.2822 8.8615 12.2126 -4.78815 -8.04326 1.85351 -508 1 0.512396 2.83902 7.01376 3.84696 0.0782361 15.1378 -509 2 0.640445 3.53836 7.66576 0.959953 5.26089 -8.6545 -510 2 0.680944 2.06786 7.56376 2.06531 -6.50055 -6.8896 -511 1 0.435055 15.2675 6.92024 15.2549 -35.398 4.87844 -512 2 0.621058 15.2814 7.87767 -6.30652 4.63478 -5.55491 -513 2 0.767833 14.3496 6.68755 -16.1257 30.2961 -2.9732 -514 1 16.9932 7.01767 15.3053 -26.5651 1.45521 -6.17716 -515 2 17.7481 7.60304 15.1777 11.1425 -6.61607 -1.97906 -516 2 17.2478 6.0923 15.4082 16.5215 2.79636 5.68328 -517 1 9.018 12.4253 8.12635 6.95093 19.302 15.9025 -518 2 9.42759 11.8305 7.48541 -10.9396 -6.20971 -13.8418 -519 2 8.05723 12.5431 8.02215 9.94353 -10.4145 -8.12359 -520 1 1.2603 1.92339 3.03777 4.00037 -11.2111 -0.333139 -521 2 0.985763 2.4239 2.25859 3.27899 1.87382 4.37683 -522 2 1.94434 2.40743 3.53125 -8.95634 4.24445 -6.71947 -523 1 4.13152 15.1081 9.6737 -15.9579 5.42681 13.2475 -524 2 4.06185 15.276 8.72578 6.37214 -2.02945 -0.454299 -525 2 5.01049 14.775 9.87491 6.77649 -3.08542 -5.82222 -526 1 7.18656 2.18024 14.5742 6.63684 0.423238 1.66106 -527 2 6.97291 1.78224 13.7284 -0.102066 -5.66692 0.745345 -528 2 7.71431 2.94579 14.3335 0.160548 4.26015 2.86325 -529 1 18.6004 14.6938 2.16823 2.76542 -5.02319 -0.780568 -530 2 0.802927 15.1539 2.18876 5.80577 -4.93168 -0.456722 -531 2 17.9585 15.3989 2.13554 -15.1748 6.08707 3.47143 -532 1 9.94779 2.77101 12.9402 13.7079 -4.8088 0.992354 -533 2 9.86912 2.18708 12.1681 -6.43941 0.85112 1.08944 -534 2 9.26112 3.44421 12.9098 -9.63803 -0.00730006 -3.05418 -535 1 2.82654 8.93218 13.0337 -16.8853 -9.00607 0.122573 -536 2 3.25687 9.752 12.7946 6.59476 15.835 -2.70012 -537 2 3.50997 8.32082 13.3007 12.5319 -6.06263 8.37491 -538 1 3.22862 8.37837 3.65188 -0.226515 1.69475 29.0088 -539 2 3.688 9.03214 3.10752 1.26352 6.15003 5.24259 -540 2 3.37942 8.56962 4.62044 0.873457 0.138782 -29.442 -541 1 5.6209 7.19208 8.52428 9.74274 9.28918 -7.76376 -542 2 5.82768 6.24803 8.58864 -11.1579 -1.95789 2.42461 -543 2 4.98617 7.45468 9.2041 -0.288223 -8.23268 4.91577 -544 1 14.8711 1.29057 2.00464 8.31119 17.2873 -6.28041 -545 2 14.835 2.11415 2.48745 -9.33397 1.40045 17.6104 -546 2 15.2356 1.62076 1.17953 -0.998754 -14.9614 -12.238 -547 1 8.25883 15.2026 0.830681 5.29747 -5.49957 9.6471 -548 2 8.95156 15.1522 1.50066 13.8019 -1.55539 -6.59484 -549 2 7.5748 14.6468 1.22478 -8.81297 0.605757 -6.77665 -550 1 15.6232 1.34362 7.23598 -18.647 -1.91314 -11.6656 -551 2 14.9897 0.764646 6.76092 12.0508 5.58891 7.1025 -552 2 15.1447 2.18632 7.33027 3.5178 -4.19741 5.22167 -553 1 4.94904 13.0769 18.5237 9.6722 0.589191 0.374268 -554 2 5.36668 13.208 0.749415 -4.04426 -2.7658 -6.21312 -555 2 5.63686 13.3362 17.8955 -3.04446 1.7017 1.4528 -556 1 15.3696 8.47999 18.1528 -1.21138 17.1653 -12.6794 -557 2 15.695 9.10606 17.469 -1.13375 -12.9806 6.06144 -558 2 15.1122 9.07709 0.225504 3.72099 -3.98362 5.25331 -559 1 12.0892 3.03182 18.3639 -14.1234 30.4246 -7.06661 -560 2 12.0418 2.65673 0.600248 11.0312 -14.2758 -1.1161 -561 2 12.4684 2.43863 17.7097 5.58993 -13.4699 6.64437 -562 1 13.2076 12.6677 5.18878 -11.1257 12.6934 -18.8931 -563 2 13.6382 11.873 4.85103 6.50507 -2.50005 7.23376 -564 2 13.4408 12.7972 6.11334 1.90386 -8.97209 5.02297 -565 1 6.04179 7.07685 0.0416979 2.64097 -12.2137 0.441028 -566 2 5.97681 7.98433 18.9573 -0.86164 23.926 -2.06041 -567 2 5.22747 6.68409 0.369779 -2.28588 -4.24693 2.31783 -568 1 17.7316 15.9939 15.0114 -15.9363 1.83518 -2.01139 -569 2 16.8954 16.4456 15.035 -7.98632 8.38962 22.0218 -570 2 17.7728 15.8943 14.0703 21.4922 -14.9825 -23.1623 -571 1 13.1856 0.993654 16.5812 4.51688 -6.04585 -7.39508 -572 2 14.1484 0.841574 16.6066 -7.22778 -1.30407 6.3933 -573 2 12.7998 0.141541 16.3207 3.39554 1.08214 8.76474 -574 1 11.0918 14.5789 7.23122 -0.0827639 9.53574 4.16562 -575 2 10.4295 14.1218 7.74457 -13.7426 -4.81361 3.6986 -576 2 11.9118 14.1808 7.52276 7.59678 -9.08814 -4.3045 -577 1 17.5016 8.6119 2.09076 15.8147 11.2146 7.10458 -578 2 16.6678 8.4072 2.52184 -8.49554 -5.1851 -0.954934 -579 2 17.6089 8.02126 1.34907 -7.08963 -15.2245 -7.94382 -580 1 12.3468 7.97644 1.98939 8.16003 1.60059 13.0036 -581 2 12.1059 8.91014 1.92161 -4.12319 -5.14517 -8.91961 -582 2 11.9653 7.48445 1.25112 -3.43761 0.267259 -0.201848 -583 1 11.9018 14.6174 10.3415 -1.61415 6.01794 0.545715 -584 2 12.1103 13.7968 9.87035 -7.85836 7.68399 3.13223 -585 2 10.9576 14.8558 10.2015 13.8599 -12.9225 1.87067 -586 1 6.88302 7.0351 15.5985 0.0361083 -3.88964 -3.36213 -587 2 7.78537 7.14813 15.233 -9.24764 2.66089 10.2853 -588 2 6.74206 7.63616 16.3488 6.91006 -2.15529 -8.72434 -589 1 7.99721 4.71198 13.4628 5.66523 -8.00363 0.660216 -590 2 7.27921 4.81457 12.8289 -1.54019 0.966988 -4.0678 -591 2 8.48375 5.53924 13.4635 -1.88422 3.21799 -0.709238 -592 1 13.4036 12.1691 14.2716 3.14721 5.94494 7.46154 -593 2 13.2707 11.2057 14.207 -2.45791 4.15826 -3.3873 -594 2 13.8696 12.4652 13.4742 -1.1423 -6.74147 -2.23487 -595 1 14.8179 9.43426 7.29668 -6.36233 -11.9657 -8.30628 -596 2 15.5946 9.98871 7.43973 -1.00608 2.08043 5.84882 -597 2 14.0417 9.81939 7.70717 2.29675 7.38462 3.05591 -598 1 12.6631 17.0342 3.08686 -0.647851 26.0284 13.2632 -599 2 13.0189 17.4392 3.9047 -6.62985 -13.126 -8.67274 -600 2 12.0984 17.7464 2.72355 6.77056 -16.0012 0.625123 -601 1 1.16659 7.14982 17.4488 -22.2539 0.168591 -14.6305 -602 2 0.289944 6.86023 17.7803 4.99818 12.4666 0.0121858 -603 2 0.976074 7.62854 16.6106 6.60301 -8.93429 9.27073 -604 1 12.7913 5.13723 15.6659 26.8924 -5.83385 4.65231 -605 2 13.5397 4.50448 15.7352 -14.8898 5.20509 -1.35689 -606 2 13.2524 6.00122 15.6738 -9.3883 -7.24139 -3.09335 -607 1 2.50717 3.39641 5.02544 -4.94238 4.99772 43.075 -608 2 1.86502 3.10611 5.74586 16.3729 8.7954 -24.7542 -609 2 3.07143 4.08677 5.47722 -17.3542 -15.0389 -19.8763 -610 1 8.33721 11.2536 13.4671 -31.8218 12.3906 11.8554 -611 2 8.27902 11.0779 14.4347 20.4393 -8.01279 -19.4916 -612 2 9.11607 10.9377 12.9927 6.53682 -12.2231 14.6875 -613 1 12.8982 1.36842 13.3393 -2.38428 13.9081 -24.9925 -614 2 13.3657 1.32357 12.4816 4.13856 -5.14841 14.3736 -615 2 12.4149 2.20238 13.2267 1.28817 -6.58848 11.7421 -616 1 6.36101 13.6632 2.13728 5.84509 3.64922 20.165 -617 2 5.80267 14.0802 2.81815 -1.42815 -2.61112 -9.48922 -618 2 6.96781 13.1347 2.6793 2.58248 -4.73497 -8.11447 -619 1 15.9275 6.58906 12.776 -13.2255 -11.9143 -7.63467 -620 2 16.5079 7.05171 12.1721 3.66176 7.36442 -5.52267 -621 2 16.2877 6.70509 13.653 8.87525 3.50761 9.55012 -622 1 16.8403 0.7053 9.59425 -10.8287 -6.51914 0.180126 -623 2 16.6786 18.4058 9.8215 7.5744 10.512 -7.34073 -624 2 16.3431 0.86575 8.76743 6.96547 -2.88011 1.97602 -625 1 6.14042 11.7236 8.37935 -13.4401 -40.1875 -12.4491 -626 2 5.21965 11.5178 8.67227 17.9013 7.59491 -1.88002 -627 2 6.47134 10.8481 8.01351 -3.81201 28.7474 13.2691 -628 1 2.85976 8.65216 0.41009 29.1416 -12.2873 -0.261225 -629 2 2.35956 8.19684 18.3517 -12.3126 13.3733 12.5274 -630 2 2.40304 9.34487 0.902258 -18.8466 -1.4582 -10.1697 -631 1 10.1473 10.4614 6.51315 3.14709 -2.48115 -1.63688 -632 2 10.5898 9.76783 7.02035 -1.8228 -0.602608 0.477386 -633 2 10.6086 10.4674 5.65949 -3.20151 3.83187 3.87642 -634 1 6.7508 15.7003 6.55579 -3.66232 16.9823 8.74149 -635 2 7.17195 16.1106 7.3235 -0.889674 -7.99055 3.10182 -636 2 6.78205 16.4211 5.90999 7.33374 -8.97986 -9.58603 -637 1 6.44532 13.1371 5.60194 -4.00449 -9.15456 -0.382904 -638 2 6.60496 14.011 5.98141 3.67218 -1.64471 2.17047 -639 2 6.02503 12.5975 6.28414 2.5909 4.19611 1.89612 -640 1 16.8064 12.5561 9.82402 0.581653 -6.91502 5.14494 -641 2 16.9779 11.8749 9.14515 -1.61791 10.9714 -1.54419 -642 2 16.8208 13.4318 9.41997 2.06437 -4.78596 -5.13994 -643 1 6.05928 2.9442 2.82556 1.25802 -7.30262 2.82421 -644 2 6.27309 3.83898 2.57954 7.79966 17.9541 1.71249 -645 2 5.71238 2.57735 2.0082 -4.75947 -10.8151 -3.84195 -646 1 10.8984 3.29285 3.29228 5.15622 -3.79068 5.20633 -647 2 10.3299 4.01236 3.59418 -0.748764 -1.25701 -6.51467 -648 2 10.5397 2.95527 2.46424 -5.70132 0.188995 -0.608043 -ITEM: TIMESTEP -30 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.74009 7.04233 17.938 19.1777 -3.19214 -7.49225 -2 2 7.80649 7.00854 18.1244 -14.093 -2.50808 3.42214 -3 2 8.91581 6.41795 17.2214 -5.10918 0.448792 4.2696 -4 1 18.6171 8.27942 6.83462 -12.32 14.9255 -3.46236 -5 2 0.0642234 8.14825 5.88022 8.8384 -8.96826 -1.74433 -6 2 0.471057 7.61284 7.31078 8.78566 -8.6497 2.36561 -7 1 8.41948 18.604 6.83196 -7.31709 9.89495 0.0475112 -8 2 9.31705 0.18142 6.57583 5.64527 1.22556 -0.782264 -9 2 7.87491 0.677395 6.4693 3.49499 -4.79599 0.294282 -10 1 6.58709 1.81441 11.6738 -9.76955 10.2882 13.9968 -11 2 5.91112 2.25954 12.2323 7.89399 -9.20897 -13.0604 -12 2 6.23103 0.933026 11.5157 -4.21921 -5.78552 -0.720022 -13 1 7.09426 5.71845 2.37594 5.34919 -15.1759 8.94595 -14 2 6.67772 6.26147 3.06365 -7.93287 1.62685 -13.8275 -15 2 6.91151 6.0744 1.49958 -5.30903 10.9181 0.766926 -16 1 16.2033 10.1932 16.1102 25.1038 -14.8345 -4.68499 -17 2 17.1811 10.2276 15.9712 -26.7737 6.31541 3.48142 -18 2 15.8826 11.0697 16.3304 -0.495148 7.87416 1.92317 -19 1 10.6275 14.9681 2.33481 4.63974 12.4061 -8.88569 -20 2 10.5525 14.5877 3.21874 0.475518 -3.93386 2.29786 -21 2 11.1735 15.7673 2.45016 -5.17002 -7.496 3.37274 -22 1 17.1558 8.25893 10.4932 -6.40301 -0.466841 8.61163 -23 2 16.8014 9.01233 11.0035 2.41501 -9.01393 -1.96838 -24 2 17.9838 8.5563 10.1014 3.2569 5.37409 0.738347 -25 1 14.813 15.8567 16.3841 0.422148 6.97991 -3.34819 -26 2 13.9021 16.1825 16.382 -1.86689 -1.60487 0.125842 -27 2 14.9304 15.3999 17.2268 -3.27081 -1.81494 5.72738 -28 1 12.1434 13.4089 0.461034 6.76243 -11.3039 1.90058 -29 2 12.0273 13.3364 18.1404 -4.47443 10.9984 5.76772 -30 2 11.5266 14.0334 0.870976 -2.78837 -1.53089 -3.65161 -31 1 9.27697 5.43199 4.02458 -7.91052 -7.29997 -7.2337 -32 2 8.84655 5.10212 4.83549 0.848683 4.58319 -8.36746 -33 2 8.59135 5.35221 3.31849 12.3251 4.32217 11.9863 -34 1 1.81829 4.21991 11.6429 6.07059 -17.107 12.3126 -35 2 1.72876 5.16246 11.8251 -3.56412 5.27463 0.970751 -36 2 2.25117 3.81723 12.4298 -6.51129 5.35444 -16.475 -37 1 2.00161 6.82001 8.34658 4.25884 -4.64897 6.26816 -38 2 2.3883 7.2423 9.12712 0.123274 4.2764 -6.11357 -39 2 2.06217 5.87963 8.57415 -6.89287 0.824976 -4.38383 -40 1 5.40511 4.42179 7.95561 5.36611 -11.1614 7.9457 -41 2 5.37943 3.4545 8.00651 8.07147 0.734095 -1.60012 -42 2 4.74745 4.62621 7.29567 -7.31573 12.7226 -8.35968 -43 1 3.27976 2.92717 17.5269 -2.61436 17.3567 -5.43199 -44 2 3.96706 3.40529 17.0145 -5.77518 -10.9103 1.73426 -45 2 2.73687 3.63363 17.9263 6.62302 -5.15647 1.61932 -46 1 7.46558 5.28438 6.08942 -8.18758 20.8516 25.3808 -47 2 7.86532 6.07017 6.49581 9.60667 -5.12281 -7.79846 -48 2 6.93507 4.98822 6.84771 -4.13165 -15.5457 -12.384 -49 1 9.77734 7.00329 11.9774 4.77277 1.25087 12.6605 -50 2 10.3838 6.43919 11.4894 -2.2356 -0.795019 -4.50196 -51 2 9.03042 7.20515 11.401 -0.391647 0.322053 -6.58611 -52 1 14.0794 3.58589 8.07965 12.1281 -3.68665 15.0324 -53 2 13.9224 4.24013 7.41233 -5.94016 13.6931 -8.832 -54 2 14.4997 4.05823 8.8235 -7.49262 -7.6028 -6.06268 -55 1 4.66909 17.2524 3.98463 -11.974 -6.63251 3.44703 -56 2 5.54996 17.5659 4.2137 3.76078 6.9996 -9.15965 -57 2 4.29017 17.6906 3.19701 6.52868 -0.394456 6.67531 -58 1 16.4992 16.6027 10.1206 -21.6924 9.71885 22.6747 -59 2 15.7868 16.8403 10.7484 14.9981 -6.02669 -3.77625 -60 2 16.0155 16.0666 9.49209 1.7904 -6.99745 -11.6514 -61 1 1.97502 4.88502 0.412911 -0.608987 3.87721 -1.07962 -62 2 2.72637 5.27959 0.897705 -7.05745 -2.41863 1.64934 -63 2 1.49341 5.65258 18.7073 9.30006 -4.776 -0.647009 -64 1 11.7125 13.3331 16.298 -5.19121 -16.9939 -9.12414 -65 2 11.2215 12.495 16.3147 -7.17559 5.00423 10.7559 -66 2 12.3053 13.159 15.554 3.20757 8.82206 0.62976 -67 1 10.1364 11.0457 16.9267 -8.25027 -0.64471 -2.79768 -68 2 10.5138 10.1546 16.8726 -0.811727 0.343111 1.84422 -69 2 9.16904 10.9405 16.8614 10.4447 -1.98124 -2.23602 -70 1 11.7196 17.4866 13.4532 0.688277 4.88805 11.3616 -71 2 12.4565 17.1915 12.9059 2.31052 0.20251 -3.63622 -72 2 11.8417 18.4468 13.5823 3.75325 -8.25615 -8.02045 -73 1 6.38436 9.31353 12.2227 -10.6166 9.98881 15.1897 -74 2 6.82973 8.96514 11.4526 14.2312 0.227315 -7.303 -75 2 6.92633 10.0292 12.607 -0.115112 -8.7725 -6.80594 -76 1 16.2215 12.7689 2.69197 14.2202 2.36446 -2.70282 -77 2 17.0315 13.2181 2.42332 4.27042 -4.81366 0.268886 -78 2 15.6299 13.4985 2.86911 -16.5638 6.55953 0.86202 -79 1 0.643858 12.5819 5.90471 10.4355 0.0636689 -1.96923 -80 2 0.972356 12.3928 5.01972 -0.601341 2.21783 -2.79245 -81 2 18.3387 12.6591 5.78833 -5.81166 2.35718 1.0682 -82 1 5.2154 16.4273 18.4533 5.05017 -7.28804 7.26993 -83 2 5.85096 15.759 18.1791 -0.38035 -3.88529 -12.2081 -84 2 5.53459 16.6741 0.678671 -3.42073 7.449 3.19712 -85 1 0.551654 7.64481 4.10641 16.2354 21.1246 -10.5626 -86 2 18.6183 7.98546 3.39603 3.07966 -1.83327 6.1622 -87 2 1.42708 8.08449 3.93576 -19.267 -16.5837 1.18512 -88 1 3.12227 8.91534 6.50802 24.2291 -0.585626 7.1452 -89 2 3.7382 8.63748 7.22391 -17.1573 3.17125 -13.7643 -90 2 2.22482 8.81583 6.82729 -5.68465 -1.73896 5.22193 -91 1 7.30086 10.3189 16.2323 -15.6545 -0.122126 6.34207 -92 2 6.59019 10.5178 15.6183 5.33711 0.792532 -4.64 -93 2 6.81196 10.2023 17.0683 9.00195 1.1125 -0.831229 -94 1 11.1139 1.03369 5.01342 4.3303 1.68398 -12.6705 -95 2 11.3068 1.80352 4.46111 -2.07011 7.18197 9.97137 -96 2 10.7762 0.428462 4.34613 -4.44642 -9.51924 3.00218 -97 1 4.39584 2.7383 13.2149 -0.390466 4.89753 -17.2666 -98 2 4.70663 3.24132 13.9776 -1.24631 -10.9908 10.3904 -99 2 4.24133 1.79775 13.4334 4.65854 7.0575 9.14841 -100 1 8.38523 10.0971 1.80824 -1.28714 19.1329 -0.644156 -101 2 8.30354 10.8052 2.48172 0.822207 -7.93375 -7.37013 -102 2 8.79223 9.36658 2.27287 1.71369 -9.23717 4.71722 -103 1 10.4729 1.73916 15.5717 11.6995 -6.53653 -13.4069 -104 2 11.3877 1.45477 15.4183 -5.50109 4.13915 12.9036 -105 2 10.2466 2.11684 14.7151 -9.31794 0.949785 -3.28817 -106 1 2.72932 12.8923 7.77007 2.13638 -2.03638 4.95693 -107 2 3.24355 13.6603 7.47881 -3.48119 -3.6232 -2.9431 -108 2 2.14523 12.6528 7.03806 -2.13852 4.70731 1.87174 -109 1 3.67999 11.6951 5.25129 1.06179 2.30609 -7.65488 -110 2 3.48397 10.8814 5.71277 1.07183 -5.39866 6.20843 -111 2 2.98047 11.7882 4.59744 -0.426908 3.81831 -2.62473 -112 1 6.82829 14.472 16.8976 7.24547 -11.7087 -0.510459 -113 2 7.70535 14.0752 16.845 -3.98439 5.03843 1.85271 -114 2 6.50852 14.4918 15.986 -3.30226 9.38599 0.302494 -115 1 14.1912 14.5549 3.37889 -4.65321 -1.5346 -2.40618 -116 2 13.6567 15.3531 3.27958 4.16996 -0.562804 -5.50008 -117 2 13.6356 13.9417 3.87468 5.16163 -0.564442 6.07906 -118 1 8.32326 18.1549 16.0383 38.0123 0.723105 5.33509 -119 2 8.90126 17.4596 16.3629 -14.277 -18.5473 4.85232 -120 2 9.02384 0.130446 15.7883 -15.867 17.9211 -5.43461 -121 1 4.72767 1.62379 4.93271 -17.6379 -0.985038 1.9521 -122 2 3.81401 1.95679 4.84992 11.4813 -1.52324 3.97162 -123 2 5.23321 2.13073 4.30096 3.99283 5.81443 -10.8958 -124 1 15.0185 12.7583 16.4307 33.5549 -15.7429 -8.88385 -125 2 14.6322 13.2399 17.156 -17.5625 6.9837 5.99474 -126 2 14.4538 12.6352 15.6516 -10.3238 6.55553 8.00439 -127 1 15.7718 18.4254 16.841 -12.0797 -5.1952 -2.21012 -128 2 16.3284 18.515 17.6327 0.946096 -4.9786 -5.09166 -129 2 15.4084 17.517 16.8347 11.7053 8.22526 2.07191 -130 1 1.18057 1.17309 16.5558 11.0398 2.91722 -0.500753 -131 2 1.84524 1.84688 16.7601 6.86303 -5.43895 -3.7977 -132 2 0.618264 1.22767 17.321 -11.8887 1.06625 6.89733 -133 1 18.1125 4.54155 15.913 0.560198 2.18648 6.37111 -134 2 18.4591 4.08913 15.1466 2.75843 -6.08521 -5.17788 -135 2 18.7597 4.4472 16.6204 -1.36812 0.49592 -3.69459 -136 1 12.2402 16.9779 16.1352 2.31512 -6.99762 -15.3414 -137 2 11.5952 16.4515 16.6081 -8.3163 0.999648 8.5775 -138 2 12.0081 16.8315 15.1982 2.22798 9.47321 6.13039 -139 1 15.9623 2.53119 18.0207 2.93621 -4.28086 -0.122131 -140 2 15.5695 3.22825 18.5544 -2.43998 7.63429 -5.2422 -141 2 15.6676 2.68289 17.1026 2.19807 1.36349 7.25858 -142 1 6.70368 13.8359 10.2288 1.24588 -18.109 -1.49583 -143 2 6.57782 13.5214 11.1319 -1.51171 6.96132 4.85856 -144 2 6.68827 13.0063 9.72453 -2.19505 9.55036 -5.72862 -145 1 10.1309 18.2871 2.76796 -14.3596 -6.47533 0.342864 -146 2 10.2029 0.342366 2.11266 2.51428 7.52943 -3.11917 -147 2 9.22516 17.9366 2.63576 15.7336 3.88756 2.50188 -148 1 2.99532 17.7363 6.09725 27.6457 -0.367768 9.57951 -149 2 2.17297 17.7876 5.61616 -10.9588 -3.8104 -13.5012 -150 2 3.724 17.7747 5.44639 -16.7072 2.57282 0.579206 -151 1 12.5761 16.9143 8.00615 -13.9856 15.3012 3.95273 -152 2 11.7456 16.4539 7.8426 4.73348 -10.9119 -5.17088 -153 2 12.3021 17.5765 8.66814 13.2598 -3.61726 -0.932189 -154 1 14.882 15.2803 8.24971 10.681 -0.761738 -5.80123 -155 2 14.3225 16.029 8.07669 -22.8014 8.12514 9.31404 -156 2 15.4227 15.298 7.45407 7.11517 -7.78554 -3.15381 -157 1 17.6329 18.2578 0.365715 -0.853361 22.9802 4.00517 -158 2 18.5235 17.9699 0.161776 5.93848 -16.2402 -3.481 -159 2 17.7627 0.512218 0.708086 -5.13428 -6.58263 -1.39758 -160 1 0.88251 10.4012 1.38524 10.7451 13.2218 -5.20703 -161 2 0.0659506 9.93794 1.52098 -14.8693 -14.1338 10.0664 -162 2 0.630973 11.1288 0.804044 1.28572 5.25949 -2.19783 -163 1 1.64115 12.2217 3.35193 -3.18006 -13.1055 -18.8251 -164 2 1.37082 11.5062 2.75067 2.88651 -5.3868 11.6868 -165 2 1.67765 12.9428 2.72371 4.09986 15.3051 6.03005 -166 1 0.58147 17.2398 4.87485 -10.389 -0.219728 20.623 -167 2 -0.122589 17.8866 4.86961 1.40048 11.6397 -9.93657 -168 2 0.410626 16.8027 5.7206 11.49 -10.3372 -7.14723 -169 1 1.11352 0.964392 9.43077 -4.94184 3.64088 -20.8453 -170 2 1.20387 0.588778 10.3126 -0.847456 -3.79009 5.67247 -171 2 0.226103 0.72639 9.1141 8.25621 -1.04795 9.52173 -172 1 16.7603 2.33922 13.2874 -3.33679 -13.7714 7.5216 -173 2 16.8475 2.59005 12.3669 3.49604 3.27514 -7.50745 -174 2 16.539 1.38388 13.2956 1.74648 12.4468 1.52133 -175 1 2.56382 15.8252 12.169 -1.32309 5.18512 -19.2115 -176 2 3.14843 15.408 12.7949 3.95332 -3.2625 9.96296 -177 2 3.02181 15.7534 11.31 -3.03818 -3.40517 4.91625 -178 1 16.4251 15.6276 5.98753 2.75225 -2.61515 5.58966 -179 2 17.3447 15.6415 6.33695 -10.8386 4.94036 -7.12539 -180 2 16.2312 16.4474 5.48017 12.4296 -10.8984 6.26847 -181 1 5.80144 5.06794 11.7894 5.49032 -3.99323 1.93812 -182 2 5.42192 5.63452 12.4754 -2.65214 7.25607 -4.62846 -183 2 5.38258 4.20716 11.9011 -4.64894 2.39601 -1.00669 -184 1 15.1781 4.86184 0.728524 -4.34825 6.76152 14.6306 -185 2 15.2668 4.67158 1.68153 -8.60174 -1.32446 -9.75027 -186 2 14.3367 5.34751 19.2902 10.4034 -8.61994 -3.37533 -187 1 16.3306 16.3549 2.10387 -3.60874 -8.17165 19.4202 -188 2 16.1436 16.7757 2.96383 0.821724 -8.86269 -6.10473 -189 2 16.4161 17.1032 1.53428 7.22132 12.8567 -17.8694 -190 1 0.267773 4.86229 3.80408 10.7738 -14.2237 3.39069 -191 2 0.48911 5.8014 3.76313 1.80944 1.44211 5.87769 -192 2 1.0394 4.38382 4.18029 -13.1099 14.4171 -4.44332 -193 1 2.95694 15.0447 15.0954 -6.10325 -16.3486 9.96696 -194 2 2.71126 14.628 15.9563 6.59243 11.9398 -10.1751 -195 2 2.48371 15.8886 15.0723 0.827451 0.569437 4.39106 -196 1 1.13642 14.6155 9.54099 -48.9591 -6.29818 10.1377 -197 2 2.0574 14.6763 9.37448 31.1561 -9.052 1.81392 -198 2 0.917533 13.7788 10.0133 17.9146 13.2649 -10.59 -199 1 13.6267 16.618 11.5309 -14.0517 -2.94194 4.54584 -200 2 13.2284 17.3872 11.0909 1.36391 -4.96948 -3.72009 -201 2 13.0435 15.8681 11.2876 10.4622 6.11411 -5.34277 -202 1 4.69594 1.47637 0.748111 -12.1621 -0.739309 -0.414133 -203 2 4.0907 2.00679 0.20438 8.77888 0.173625 -0.66482 -204 2 4.10511 0.858084 1.19895 3.99089 -4.2391 -0.703649 -205 1 1.43799 18.5334 11.8677 4.48354 -19.5441 -2.70285 -206 2 1.28309 0.34807 12.6964 -2.38454 7.77338 6.6957 -207 2 1.65634 17.6099 12.1011 0.514199 12.3996 -0.852918 -208 1 11.5339 10.1172 4.0507 5.82948 9.6286 -18.4863 -209 2 11.2843 10.5321 3.18756 5.15824 -8.38498 16.2271 -210 2 12.5124 10.093 4.04255 -10.5657 0.881913 4.0585 -211 1 8.32129 12.1582 3.72502 1.53352 8.77417 8.44763 -212 2 9.09494 12.6645 4.01218 5.78128 -3.64141 -7.92941 -213 2 7.76311 12.2518 4.50437 -12.3191 -3.17133 -0.801295 -214 1 14.3738 4.02512 3.28302 13.4457 8.56362 13.3606 -215 2 15.0833 4.15474 3.94873 -8.39321 -4.82495 -4.85792 -216 2 13.6328 4.57269 3.59478 1.91801 -3.79011 -4.78214 -217 1 5.59001 1.69403 7.5104 -22.1497 -9.71937 -16.3739 -218 2 4.92965 1.04535 7.86703 17.0022 15.2682 -3.23125 -219 2 5.33019 1.76513 6.54994 10.6546 -4.2597 24.8978 -220 1 17.8762 1.11593 4.87562 6.9502 3.59021 1.61777 -221 2 18.6375 1.36949 4.33979 -2.23157 -1.53514 -7.48501 -222 2 17.9489 1.70322 5.63717 -7.55192 -1.12522 1.72169 -223 1 6.82082 9.41417 4.48467 7.28036 -1.61815 9.25922 -224 2 6.87733 9.61398 5.42883 -5.7945 0.587378 -0.0554941 -225 2 7.74179 9.22243 4.26363 -0.0627487 -3.5933 -6.80471 -226 1 2.67079 14.9403 1.9639 10.8093 -10.5544 22.1131 -227 2 3.25117 14.6591 2.70117 -12.0207 4.93014 -5.95014 -228 2 3.29732 15.1077 1.27121 3.13815 4.27624 -15.5237 -229 1 17.3067 12.913 13.1683 10.6019 -31.6629 4.62367 -230 2 16.4497 13.2737 13.3972 -3.78483 16.2252 -3.80314 -231 2 17.8834 13.5891 12.8053 -8.28955 15.595 1.58636 -232 1 14.9867 10.5664 1.39303 17.3246 -3.28745 6.09509 -233 2 15.5958 11.2392 1.752 -7.58668 -4.78908 -2.0363 -234 2 14.1528 11.003 1.29225 -13.717 8.26159 -1.38466 -235 1 5.69708 6.86241 4.54741 10.2551 2.99419 0.383868 -236 2 6.12873 7.74081 4.58523 -8.39477 -7.3362 -0.690872 -237 2 6.29159 6.23392 4.98874 0.140081 3.89587 3.34658 -238 1 8.04621 8.27418 10.2318 -1.25624 6.00125 -7.48209 -239 2 8.67166 8.94213 9.92965 6.80147 7.39227 7.14523 -240 2 7.62794 8.03247 9.40376 -7.32264 -11.607 2.12748 -241 1 13.4746 18.3625 5.78211 -13.502 7.51331 -2.26288 -242 2 12.7551 0.364455 5.61988 6.67968 -8.24018 -2.37745 -243 2 13.1168 17.8207 6.50434 6.50164 -0.829271 0.111391 -244 1 0.226362 2.58719 0.131375 -15.5932 24.0028 11.6326 -245 2 17.9693 2.93929 18.6394 3.5786 -16.3529 -5.12341 -246 2 0.708035 3.3711 0.44675 7.58398 -8.21165 -4.7522 -247 1 12.703 11.0237 9.75181 24.9284 -7.65781 8.94422 -248 2 11.7937 10.9936 9.46616 -11.7502 -8.38149 -1.23796 -249 2 12.9608 10.1029 9.99094 -10.5021 9.57622 -2.72207 -250 1 0.761974 12.2205 11.0816 -4.15363 -6.09516 -21.355 -251 2 18.4366 12.288 11.0674 3.38909 -0.754442 8.49561 -252 2 1.11175 12.4338 11.9478 -3.68194 5.91832 8.04416 -253 1 5.07253 7.26896 13.4467 3.90397 -0.0234352 3.77117 -254 2 5.61152 7.96046 13.0436 -1.11485 3.21213 -6.58832 -255 2 5.53238 7.13074 14.2827 -1.05457 -4.33313 3.81413 -256 1 1.23629 6.9109 11.8337 28.2892 12.95 23.6673 -257 2 0.51347 7.34016 11.3984 -13.736 7.24235 -8.87687 -258 2 1.75935 7.64669 12.2495 -13.9201 -17.9067 -15.9983 -259 1 15.4873 9.53008 12.3182 -0.383493 4.12812 -8.89679 -260 2 15.0655 10.399 12.2152 3.51435 -2.6855 7.45914 -261 2 15.2649 9.14784 13.1724 -1.90612 6.52608 2.19385 -262 1 16.6085 12.8345 5.46896 -3.55761 11.1023 -1.95777 -263 2 16.4419 13.7896 5.48874 0.313493 -0.193839 12.6146 -264 2 16.4475 12.6632 4.54137 -0.0496347 -14.7353 -8.15109 -265 1 6.20534 9.98194 0.0899104 18.0768 -8.37359 0.258846 -266 2 5.59572 10.4068 0.70246 -2.59094 3.74961 3.89273 -267 2 7.08249 9.9872 0.527613 -14.0474 2.02387 3.58276 -268 1 12.3397 6.07843 4.05984 1.81271 11.939 -8.21694 -269 2 12.2328 6.8085 3.41842 8.48996 -4.45606 3.14495 -270 2 11.4615 5.7138 4.10837 -10.8447 -6.35959 3.05037 -271 1 0.186481 12.7968 0.194157 8.45417 -0.362633 0.823389 -272 2 0.122538 13.4857 0.868002 -3.08717 1.48078 1.57348 -273 2 18.4164 13.184 18.057 -2.66731 -2.48236 -4.34426 -274 1 3.77162 18.5917 8.57827 -20.4554 1.45559 2.68175 -275 2 3.52322 17.9715 7.87805 6.33007 3.25639 -1.82086 -276 2 2.90938 0.367014 8.76804 7.74592 -0.0744794 5.639 -277 1 7.46409 17.2961 4.48316 -14.1198 -17.2275 8.02552 -278 2 7.88946 18.1398 4.59819 4.06261 16.9953 -5.43573 -279 2 7.32948 17.1504 3.54137 6.62361 8.1702 -3.03871 -280 1 9.24056 17.0796 12.2607 -1.29913 -0.841935 -6.42698 -281 2 9.19718 16.4258 11.5387 7.57092 0.344645 9.78983 -282 2 10.1052 16.9888 12.7016 -6.07497 2.05659 -6.06408 -283 1 13.326 12.928 7.96212 4.69357 25.6567 2.07593 -284 2 13.3763 12.2768 8.65803 -4.91574 -13.7878 2.50151 -285 2 13.7353 13.7181 8.35204 8.56042 -2.58857 -8.38859 -286 1 14.9538 2.97298 15.3382 -4.29462 -11.8182 -2.96981 -287 2 14.4639 2.15222 15.1644 -2.78402 11.1896 3.17375 -288 2 15.6292 2.97829 14.6488 1.75 3.70602 0.0805282 -289 1 9.85487 15.5414 16.9955 1.72232 -1.82893 -0.169847 -290 2 10.3837 14.7676 16.7382 -3.42626 -0.271454 1.71497 -291 2 9.29261 15.2923 17.7497 4.44449 2.55726 -1.27949 -292 1 11.3089 8.30526 16.5494 -6.04997 -6.2326 7.21044 -293 2 10.5881 7.89563 16.0543 2.01853 1.78394 -3.12513 -294 2 11.4835 7.65722 17.2517 2.74023 7.81545 -1.84368 -295 1 3.836 18.1836 16.7517 -7.13385 -19.1452 -23.0441 -296 2 4.27407 17.4593 17.223 1.84106 9.67264 7.83483 -297 2 3.88222 0.348533 17.2402 4.94653 11.64 14.7969 -298 1 2.18178 4.13609 8.93005 8.1701 -0.774865 9.73019 -299 2 3.0913 3.90524 8.75773 5.46766 -1.37508 -11.1104 -300 2 2.14869 4.01328 9.88774 -11.2166 4.12208 2.959 -301 1 9.87742 10.3647 9.70242 2.63105 14.1486 10.9213 -302 2 9.56679 11.2208 9.35298 -0.359428 -9.80694 -0.658425 -303 2 10.1334 10.5423 10.6269 -4.00587 -8.10964 -6.10976 -304 1 9.70429 0.823826 10.8553 -14.0108 4.16215 1.0267 -305 2 9.1278 18.77 11.1938 11.0832 -7.32823 7.11532 -306 2 9.14207 1.22722 10.1856 4.51331 8.02138 -6.87563 -307 1 9.20617 15.1402 10.2178 -11.609 -5.72992 -0.101326 -308 2 8.7465 15.767 9.6415 2.03963 4.50002 1.17892 -309 2 8.51696 14.4821 10.4282 6.2553 7.07807 -5.66984 -310 1 0.996164 9.40777 10.3157 -31.4617 35.4735 1.80375 -311 2 1.02993 10.3821 10.3914 -11.0752 -10.4846 4.01107 -312 2 1.89609 9.22017 10.2201 37.6387 -20.6805 -6.1303 -313 1 16.8786 4.85128 8.17759 -11.2506 16.3288 -5.48708 -314 2 16.2388 5.56314 8.38188 8.44756 -9.04525 0.78656 -315 2 16.9626 4.34108 8.98054 4.36808 -7.38136 2.74573 -316 1 14.6815 14.711 0.319263 14.4838 0.937126 -3.06264 -317 2 15.2721 14.9301 1.06391 -7.87321 4.75235 -6.44468 -318 2 13.8763 14.3724 0.714255 -5.91657 -4.41648 2.02008 -319 1 3.57415 11.0448 9.58418 2.91679 3.40936 2.58946 -320 2 3.69173 11.5263 10.4228 -3.34733 -6.02301 -1.37626 -321 2 3.07399 11.6483 9.00652 3.80152 0.245021 0.575116 -322 1 11.1013 10.8086 1.33492 -13.1151 -1.75228 0.351043 -323 2 11.4484 11.639 0.990604 2.68761 3.85867 -0.677593 -324 2 10.1644 10.7789 1.04773 13.6271 -2.80152 6.25142 -325 1 13.1828 7.11823 12.837 13.875 6.93007 -2.08809 -326 2 14.1546 7.00576 12.8731 -8.73741 -0.33434 -1.11439 -327 2 12.8407 6.21951 12.8306 -5.12621 -6.60309 0.0889066 -328 1 9.62491 1.88499 0.973614 -3.42399 -6.06492 -12.2684 -329 2 8.82152 1.4846 0.597998 2.34171 8.22807 3.07369 -330 2 10.1781 2.12743 0.21359 -0.384483 0.556473 6.61436 -331 1 10.6031 13.5334 4.66686 13.636 -3.8461 -1.22567 -332 2 11.4763 13.1252 4.55872 -4.58351 -5.15517 0.0143246 -333 2 10.7077 13.9241 5.53959 -7.66657 9.10334 4.04553 -334 1 14.3485 1.75735 10.9256 -1.10429 -17.7549 1.09656 -335 2 15.1861 1.44338 10.54 -2.80824 6.90847 2.1648 -336 2 14.3834 2.71874 10.9625 8.08978 3.11888 -5.0019 -337 1 14.6333 12.3432 11.6996 -1.39952 -9.16637 -24.1357 -338 2 15.3681 12.4502 11.0746 9.0546 4.11007 14.4837 -339 2 13.9355 12.122 11.0753 -11.0061 -2.1546 9.49113 -340 1 8.24004 5.06512 9.81661 -6.73852 -15.0928 -6.1646 -341 2 7.43321 5.24609 10.2868 -7.68507 10.8263 10.6715 -342 2 8.07004 4.14881 9.53169 13.9201 5.19095 -3.88371 -343 1 1.57861 16.855 18.3455 -3.6047 -18.8696 23.6299 -344 2 1.81992 17.2862 17.5419 10.6717 7.49965 -18.3027 -345 2 1.88846 15.9289 18.2434 -7.51751 10.9825 -1.36554 -346 1 1.48469 17.2399 15.3369 -30.5992 8.85894 1.58219 -347 2 1.52903 18.0991 15.7763 5.64601 2.15314 -3.36931 -348 2 0.515015 17.0623 15.2815 21.6878 -4.25813 -0.913042 -349 1 3.6961 5.66103 6.13276 1.27154 -4.68408 -0.174538 -350 2 3.02861 6.15393 6.634 5.94065 6.05513 -0.564102 -351 2 4.2706 6.29315 5.66099 -8.13711 -1.6893 2.05746 -352 1 12.3863 9.46112 14.1898 5.64676 -22.9439 1.72589 -353 2 12.6155 8.61212 13.7476 3.53191 14.2422 4.21489 -354 2 12.2183 9.16782 15.1036 -0.67103 6.17556 -4.58111 -355 1 4.03262 15.2884 6.88962 -6.96122 -2.16466 3.53978 -356 2 3.61008 16.076 6.4989 3.67472 -5.21865 6.04109 -357 2 4.98914 15.3892 6.82497 3.29203 7.08348 -5.36605 -358 1 0.610585 8.57451 14.9167 2.06858 8.16468 9.66942 -359 2 0.571526 9.5334 15.101 -0.509723 -6.74541 -4.80249 -360 2 1.24768 8.49017 14.2004 3.24343 3.39805 -1.00154 -361 1 12.9947 8.30502 10.3347 -2.10898 5.96297 -3.02925 -362 2 13.7245 7.79451 9.98073 4.34503 -3.62623 -11.9067 -363 2 13.0194 8.04092 11.2546 -7.35013 -0.655157 9.61409 -364 1 15.3021 7.68636 3.53463 20.0464 32.042 -6.64886 -365 2 14.6007 7.2355 3.06802 -7.18972 -17.1123 8.01585 -366 2 15.7144 7.29713 4.32433 -16.1768 -11.7678 -0.766084 -367 1 17.3034 6.68003 0.0493874 -1.84179 -13.5509 -2.88881 -368 2 16.9519 5.78424 0.161568 0.711034 6.10552 3.25575 -369 2 16.5083 7.2036 18.5276 -0.473138 7.46776 -7.84911 -370 1 8.84315 6.93181 7.84628 -0.943806 11.0529 -13.3888 -371 2 9.77771 7.20927 7.80441 -6.03996 -2.82935 4.46193 -372 2 8.74315 6.27043 8.54219 4.24547 -3.80386 5.92931 -373 1 12.3578 0.616451 1.20223 7.02437 -6.39463 -1.478 -374 2 13.2861 0.535705 1.47006 -5.02329 6.70293 3.96338 -375 2 12.2631 18.6802 0.444477 -1.70715 1.25222 -1.43865 -376 1 5.64724 15.135 14.5406 -0.604856 -11.7009 0.79572 -377 2 4.70142 15.1669 14.7844 5.92695 5.15448 -4.69419 -378 2 5.94602 16.0188 14.2721 -2.36621 0.047849 -2.09121 -379 1 3.86203 6.47491 1.73695 1.36817 -0.22553 5.39386 -380 2 3.46749 7.3178 1.48065 -2.80916 3.79134 -8.60259 -381 2 4.09027 6.61791 2.66801 -1.52617 -4.74348 -3.78665 -382 1 3.89615 11.6258 12.3135 -4.96985 -7.23752 -2.42851 -383 2 4.76636 11.9561 12.5635 2.33504 5.86151 0.242199 -384 2 3.23901 12.1927 12.7515 8.69891 -3.88643 -0.482475 -385 1 5.40213 3.8611 15.8693 10.8945 -12.2769 2.09816 -386 2 6.15363 3.21949 15.8699 -18.4435 12.0745 -5.1575 -387 2 5.79254 4.73962 15.8533 3.23601 3.32406 0.742539 -388 1 14.4255 10.2871 4.42158 -5.00773 -17.9107 13.5675 -389 2 14.5181 9.70279 5.20492 2.69814 10.8256 -8.91808 -390 2 14.7837 9.77905 3.68069 -0.206993 2.85241 0.289205 -391 1 7.87167 17.3723 9.20121 -10.8695 6.25183 -3.73994 -392 2 7.03582 17.6433 9.5986 1.28641 -7.15132 6.24862 -393 2 7.9635 17.9776 8.45108 8.3983 -5.79413 -1.77097 -394 1 4.52981 14.473 3.9851 -7.27149 14.4717 16.1092 -395 2 4.4292 15.3844 4.34508 5.86047 -13.4028 -12.5476 -396 2 4.51094 13.8931 4.76638 0.622359 -0.721789 -7.97238 -397 1 14.2548 7.40188 15.768 -9.88191 3.80355 1.83721 -398 2 15.2055 7.32768 15.6782 10.3356 -1.93634 -2.70959 -399 2 14.1214 7.72007 16.6658 2.42251 2.42868 0.921806 -400 1 2.92318 18.2319 1.90056 8.21916 -2.84793 -3.01579 -401 2 2.38261 17.6158 1.3774 3.82694 3.92633 -2.29165 -402 2 2.32657 18.895 2.2462 -10.4983 4.84254 7.82145 -403 1 7.9872 1.59624 4.55123 -13.2342 7.82044 -5.09514 -404 2 7.38456 2.15817 4.04087 -4.12207 -9.74777 1.09289 -405 2 8.829 1.94177 4.28864 19.9647 -0.586446 1.64736 -406 1 2.52886 14.1331 17.7106 9.56011 -8.28606 7.0204 -407 2 2.01365 13.3855 18.0679 -1.20108 10.5585 -3.23507 -408 2 3.45026 13.9294 17.9721 -7.58546 -2.42865 -2.00823 -409 1 0.784808 1.71729 13.877 -22.3729 3.14932 11.7627 -410 2 0.820241 1.39718 14.7912 6.0833 4.21121 -6.47959 -411 2 18.4913 1.99435 13.7832 17.5446 -4.15928 -6.69512 -412 1 4.49906 18.6473 13.9354 -18.7945 1.8826 8.61585 -413 2 5.41644 18.4141 14.0419 11.9469 -5.27484 -6.26214 -414 2 4.07897 18.3597 14.7657 2.79866 5.45516 -5.58976 -415 1 7.09283 0.599142 18.3486 34.6471 -4.12786 -6.63011 -416 2 7.39021 0.234617 17.4878 -9.84259 3.28252 9.67216 -417 2 6.14438 0.553251 18.3894 -16.3447 5.16139 0.014819 -418 1 16.0881 18.4309 14.0453 5.06229 7.716 24.0321 -419 2 15.2482 18.0804 13.8032 -16.2536 -8.6858 -12.6141 -420 2 15.9952 18.587 15.0073 9.58514 -0.127307 -10.5143 -421 1 10.0776 4.50678 16.2676 12.8821 37.0646 3.31891 -422 2 10.9819 4.89306 16.3611 -10.6263 -20.5161 -3.34059 -423 2 10.1424 3.55939 16.3223 6.24363 -16.5382 -1.58612 -424 1 15.8992 17.8398 4.41934 12.2004 7.51097 -4.98004 -425 2 16.3832 18.6941 4.42415 -3.71288 -10.9395 3.02327 -426 2 14.9903 18.0494 4.62819 -9.96916 6.21932 6.5896 -427 1 6.98832 17.3871 13.7576 13.6855 5.49553 14.8404 -428 2 7.37965 17.5993 14.631 -4.71479 -0.449691 -14.3122 -429 2 7.76575 17.2997 13.1656 -13.1106 -1.1113 5.84114 -430 1 13.2824 6.5097 6.67953 4.56939 11.9611 -5.54075 -431 2 14.0532 7.04843 6.47095 5.72005 -2.26771 11.4806 -432 2 12.9258 6.37058 5.8058 -10.6331 -8.36185 -8.97535 -433 1 7.75109 2.3756 9.23631 -5.33505 -3.40336 15.3372 -434 2 7.18759 2.24157 10.0186 8.87424 2.78019 0.355864 -435 2 7.20141 2.0575 8.52046 -4.61968 -0.366971 -12.063 -436 1 15.1734 14.8403 13.6669 0.441467 -1.73197 5.96822 -437 2 15.0738 15.2212 14.5455 0.591215 -4.0348 4.14746 -438 2 14.518 15.2716 13.122 -1.09719 2.73458 -8.10719 -439 1 9.35119 8.31644 3.739 2.66762 7.66889 5.69365 -440 2 10.15 8.71947 4.13947 -5.98752 -7.29531 -6.80605 -441 2 9.38201 7.35632 3.87197 4.69073 2.10751 1.74529 -442 1 17.751 13.5231 16.4139 1.76506 1.52762 0.696064 -443 2 16.8205 13.2419 16.3833 1.32585 7.25436 -2.93419 -444 2 17.8025 14.3962 15.9827 -4.54797 -4.37418 0.927992 -445 1 4.99908 10.6417 2.69781 -10.2301 11.821 9.59097 -446 2 5.61637 10.2237 3.29708 11.0389 -6.03173 2.08237 -447 2 4.70065 11.4181 3.20566 0.509198 -9.80178 -10.0294 -448 1 3.73671 8.33589 10.2301 0.811909 12.56 -11.1256 -449 2 3.79833 9.26935 9.95307 1.30999 -3.93497 -1.66187 -450 2 3.73931 8.38186 11.1831 0.045476 -4.76093 8.99044 -451 1 16.0469 7.05349 6.21752 -8.36922 7.98368 -7.54927 -452 2 16.8656 7.47651 6.4961 3.44749 0.07849 4.67395 -453 2 16.1438 6.1088 6.32704 6.52122 -4.4821 -3.05144 -454 1 15.1289 7.04368 9.08785 10.4694 9.8467 1.75835 -455 2 15.8264 7.38614 9.67453 -3.18259 -3.19274 -6.50653 -456 2 15.1274 7.66298 8.34243 -1.48772 -3.73631 0.00250057 -457 1 6.37899 13.0555 12.8241 7.15095 -9.93714 4.62427 -458 2 7.14263 12.6042 13.2293 -5.49135 0.351509 -10.6671 -459 2 6.23455 13.8287 13.3737 -7.10156 7.81238 6.40695 -460 1 12.1361 4.49173 13.0886 -33.3605 -9.49617 -7.12831 -461 2 12.0495 4.6518 14.0281 12.9755 3.95225 11.8447 -462 2 11.274 4.06082 12.879 23.5373 6.19102 -2.9945 -463 1 11.3516 8.18262 7.87035 -14.4325 7.02786 -3.11936 -464 2 12.0471 7.65769 7.46008 8.6713 -7.43794 3.47117 -465 2 11.5359 8.26397 8.81258 10.0684 -2.50636 2.15934 -466 1 17.1915 10.8124 7.44959 -16.1176 10.6393 13.8832 -467 2 17.9047 10.1798 7.28217 -0.931293 1.13858 -10.0543 -468 2 16.9855 11.3827 6.68215 10.1883 -6.89581 1.62445 -469 1 5.25104 18.1119 11.0466 -2.03712 6.82198 -5.53245 -470 2 4.55844 17.9395 11.7023 5.22213 1.54215 -0.259713 -471 2 4.79647 18.4173 10.2467 -3.05137 -7.80568 1.06144 -472 1 7.59144 17.5428 1.82585 2.02366 6.3387 -27.4892 -473 2 7.8094 16.7742 1.27336 1.17923 0.135637 10.7354 -474 2 7.55288 18.254 1.15356 -7.65387 -5.36774 12.2151 -475 1 1.92063 12.9184 13.6023 -9.91855 -8.75107 -5.23832 -476 2 1.37345 12.2779 14.0844 5.59931 4.65398 4.03533 -477 2 2.08932 13.6638 14.189 3.88592 4.92281 2.07481 -478 1 9.68002 6.79239 14.8375 -5.9785 1.55821 1.53848 -479 2 9.8605 5.87105 15.0454 -1.79232 -6.14635 7.43903 -480 2 10.0701 6.92553 13.9753 -0.129146 4.69231 -11.1498 -481 1 15.2463 4.32976 10.758 3.34542 15.1712 12.775 -482 2 16.1952 4.27653 10.855 10.1577 -17.3864 -7.84826 -483 2 15.0718 4.96713 11.4544 -13.5892 3.80238 -1.28771 -484 1 11.2223 6.14234 0.184515 14.935 15.986 0.702496 -485 2 11.3427 5.2537 -0.179589 -9.34658 -3.11564 3.17557 -486 2 10.3073 6.45674 18.8196 -5.33379 -13.1911 -7.29958 -487 1 0.101128 11.3538 15.0994 -20.5112 19.1646 -16.3994 -488 2 18.0631 11.5965 14.4157 17.8209 -6.40715 11.0417 -489 2 18.7281 12.1498 15.6639 -2.69532 -11.5931 2.167 -490 1 7.07341 9.21118 7.26397 13.6545 -4.38359 1.14819 -491 2 6.46912 8.52168 7.54812 -6.91606 -6.22713 3.38737 -492 2 7.94495 8.78194 7.35853 -7.81842 8.24868 -3.32543 -493 1 18.379 15.4045 12.3485 -3.73833 -6.55761 4.14497 -494 2 0.693581 15.4288 12.2501 6.70794 3.85833 -5.56408 -495 2 17.998 15.8269 11.5664 0.97425 0.444703 -1.66759 -496 1 16.5516 4.36462 5.23826 -5.38189 5.67955 -17.8631 -497 2 16.655 4.28498 6.19256 13.2509 -4.37544 3.08954 -498 2 17.3965 4.59413 4.7818 -8.47419 -6.89051 15.5314 -499 1 17.7443 3.09877 10.7286 3.04827 -10.7181 -6.87848 -500 2 0.0283995 3.26624 10.9392 2.02267 5.05617 3.97045 -501 2 17.7464 2.2027 10.3321 -6.96828 10.7891 3.50943 -502 1 12.2779 0.0212452 10.1338 -0.475788 -3.12763 3.03365 -503 2 11.45 0.377358 10.5143 6.17492 -0.459139 -6.32122 -504 2 12.9469 0.721114 10.1609 -4.48032 5.31969 3.75096 -505 1 10.3747 9.79435 12.3975 0.995366 2.64477 2.84838 -506 2 11.0916 9.86004 13.0462 0.88472 -0.940912 -1.26785 -507 2 10.2331 8.84374 12.2815 -0.892889 0.226532 -0.81052 -508 1 0.549483 2.84316 7.02126 -1.47246 -21.9217 -16.5589 -509 2 0.577314 3.5439 7.66737 3.67317 4.63089 12.4819 -510 2 0.765862 2.00117 7.45653 1.04632 13.6877 4.9994 -511 1 0.405258 15.2829 6.93023 -2.49907 -5.43649 4.98244 -512 2 0.538371 14.8975 7.8327 2.16571 9.44122 -16.3162 -513 2 0.725684 14.6278 6.28848 -1.93707 -3.30699 10.9749 -514 1 17.0129 7.01771 15.2646 8.6122 -7.5627 -5.22629 -515 2 17.8138 7.53109 15.1273 -3.20292 15.4854 -2.58719 -516 2 17.4051 6.15342 15.4314 -10.2841 -6.73634 6.86556 -517 1 9.05466 12.4444 8.11302 13.0521 -10.4864 -20.5516 -518 2 9.3276 11.8473 7.39447 15.1337 1.48797 7.8591 -519 2 8.12011 12.397 7.99286 -24.7878 10.4099 9.23055 -520 1 1.26093 1.88381 3.01396 9.71768 11.5305 -0.318626 -521 2 0.781341 2.25664 2.27301 -4.68813 -2.91629 -4.97973 -522 2 1.78505 2.63319 3.35529 -3.04295 -14.2735 3.58948 -523 1 4.11799 15.1078 9.73252 4.576 2.76804 -1.92408 -524 2 4.09335 15.377 8.80945 -5.53143 0.588802 -2.3225 -525 2 5.02333 14.7824 9.83323 -1.70794 -2.53339 7.76874 -526 1 7.21252 2.18262 14.5895 -3.17269 -14.8219 8.52343 -527 2 7.02371 1.74902 13.748 4.05246 3.09826 3.19753 -528 2 7.71073 2.97164 14.4061 4.58862 11.2949 -7.92291 -529 1 18.5773 14.6793 2.1781 -14.8885 -13.9434 -3.10254 -530 2 0.806981 15.0773 2.13409 4.68638 9.16713 1.06255 -531 2 17.8879 15.3584 2.08187 6.00104 3.32119 3.09374 -532 1 9.95988 2.75708 12.9307 -3.19888 4.8993 -0.068744 -533 2 9.83509 2.14797 12.1955 3.80206 -8.82317 -3.94881 -534 2 9.20326 3.3528 12.8696 -1.08171 3.11286 5.06453 -535 1 2.85334 8.94069 13.0534 -9.07349 -10.7547 -1.24525 -536 2 3.30632 9.75091 12.8027 2.98523 12.1914 -0.768468 -537 2 3.53212 8.32042 13.3313 9.61222 -2.32206 4.81477 -538 1 3.22451 8.40753 3.67121 22.1548 25.1655 0.793749 -539 2 3.78763 9.07745 3.2153 -17.2399 -11.2925 0.757254 -540 2 3.40605 8.58793 4.60238 -4.67213 -6.04062 1.9181 -541 1 5.62069 7.18926 8.53747 6.69229 -2.05947 9.74796 -542 2 5.86853 6.28591 8.76536 -0.744086 -3.6627 -12.9201 -543 2 5.09246 7.43537 9.3012 -7.69944 9.66912 -1.05292 -544 1 14.8771 1.33506 1.99369 -4.37531 -14.3045 14.6387 -545 2 14.6174 2.14132 2.47402 3.99094 2.69357 -12.1219 -546 2 15.1274 1.48157 1.08098 3.94771 15.4277 -5.2716 -547 1 8.29964 15.2018 0.824762 -0.280237 2.12341 -18.5848 -548 2 9.0741 15.0554 1.38374 0.657448 -4.01578 8.69554 -549 2 7.56069 14.656 1.13255 5.04945 -5.16558 7.75703 -550 1 15.6052 1.34643 7.22407 3.75056 4.73875 0.699016 -551 2 15.0587 0.773182 6.67423 -5.35564 1.12746 0.995868 -552 2 15.1053 2.16848 7.37587 -1.8024 -6.33902 1.47434 -553 1 4.99443 13.0609 18.5093 -5.69789 -0.343563 -13.2097 -554 2 5.39232 13.2306 0.720212 5.08054 -1.92613 6.3414 -555 2 5.7137 13.1567 17.8693 -5.50653 4.49423 4.11534 -556 1 15.3782 8.49607 18.1492 -5.08872 -0.806473 3.30258 -557 2 15.7135 9.0139 17.4023 0.0404722 4.09908 2.1153 -558 2 15.1698 9.14329 0.203973 4.81283 -1.94937 -4.21801 -559 1 12.0917 3.05456 18.3485 5.25344 -19.9367 5.19329 -560 2 12.3328 2.56101 0.492796 -7.10973 11.5886 11.7441 -561 2 12.4167 2.41374 17.7115 -1.86526 8.77132 -18.5664 -562 1 13.1991 12.6728 5.17615 -0.124316 -0.0560055 4.18836 -563 2 13.6438 11.8331 5.03438 2.42254 -3.05364 -13.3032 -564 2 13.4089 12.8359 6.10375 -5.84435 4.2533 1.84347 -565 1 6.03469 7.1207 0.0631469 12.4635 -7.18562 -1.52206 -566 2 5.88549 8.01359 19.0305 -4.09863 7.65543 -4.79966 -567 2 5.21365 6.64029 0.190066 -5.29753 1.61074 5.21091 -568 1 17.6997 15.9613 14.987 30.7149 -12.4194 32.4504 -569 2 16.8862 16.4214 15.1458 -18.1669 6.52853 -13.961 -570 2 17.8877 15.7083 14.0822 -14.2113 6.66636 -19.3843 -571 1 13.1806 0.977208 16.5993 3.21446 -7.78263 -3.05852 -572 2 14.1069 0.725878 16.7441 -1.84519 3.55213 2.46319 -573 2 12.7536 0.148831 16.339 0.610986 0.436683 6.04854 -574 1 11.0624 14.5912 7.28204 -11.2181 -3.76258 -2.73638 -575 2 10.3867 13.9846 7.62705 2.11873 3.9908 3.08505 -576 2 11.9143 14.2091 7.50586 0.261112 -7.43153 0.664812 -577 1 17.506 8.58052 2.09005 -0.444247 -11.7988 -12.468 -578 2 16.6642 8.31502 2.4773 -2.50704 5.84538 6.9832 -579 2 17.563 7.99026 1.31874 6.86903 3.37396 8.78538 -580 1 12.3502 7.95652 1.98027 -3.36099 -5.49894 -2.13311 -581 2 11.9195 8.80992 1.98547 0.506131 9.65618 1.3531 -582 2 11.9377 7.50693 1.23044 6.6222 -7.49408 4.60604 -583 1 11.9327 14.6311 10.3511 -13.8226 21.3891 7.58711 -584 2 12.0851 13.8189 9.91206 10.3006 -23.5502 -10.4516 -585 2 11.0014 14.8158 10.1424 3.95037 3.15478 8.54077 -586 1 6.86541 7.01247 15.582 10.3214 -0.24422 -5.9518 -587 2 7.78025 7.06796 15.2658 -3.95377 -6.01896 -2.62563 -588 2 6.83046 7.729 16.2102 -7.67029 5.21932 8.6005 -589 1 8.00165 4.68416 13.4443 -21.8863 -22.7248 -23.0503 -590 2 7.36443 4.84116 12.7101 7.64348 -4.39085 15.7408 -591 2 8.44337 5.50298 13.5544 13.6077 24.8283 3.95349 -592 1 13.4082 12.1692 14.291 7.74384 0.583631 -6.74495 -593 2 13.3391 11.2097 14.1788 -8.03609 -0.555633 4.00216 -594 2 13.8852 12.4587 13.496 -2.17037 2.06617 1.19415 -595 1 14.784 9.43826 7.28323 -11.1269 12.8929 16.9671 -596 2 15.4951 10.0466 7.55684 1.33033 -10.8665 -8.82607 -597 2 14.017 9.71262 7.81429 7.01149 -4.68319 -9.50468 -598 1 12.6837 17.0142 3.10751 10.9269 -13.9095 9.51878 -599 2 12.9708 17.2813 3.99359 -6.48615 4.53386 -3.20168 -600 2 12.1282 17.7068 2.75827 -7.19321 10.5694 -1.73823 -601 1 1.13983 7.14905 17.429 -19.8537 -0.642492 -7.24746 -602 2 0.229092 6.89189 17.6928 9.24629 12.0374 -0.554306 -603 2 1.04788 7.63326 16.5858 1.73105 -6.23108 5.83737 -604 1 12.8283 5.10796 15.6891 -3.1105 -1.51238 -5.72518 -605 2 13.5351 4.46064 15.5231 -0.330328 2.49365 6.49287 -606 2 13.2544 5.98171 15.6287 1.13166 -7.6156 1.26811 -607 1 2.48175 3.38612 5.07416 -11.4746 -6.3359 16.597 -608 2 1.87059 3.13723 5.824 15.2627 10.0051 -19.3068 -609 2 3.07561 4.08306 5.41325 -9.83136 -1.83582 -2.79497 -610 1 8.32062 11.2204 13.4908 14.3326 -12.3724 2.23055 -611 2 8.41586 10.9603 14.3918 -15.5351 3.38632 26.9235 -612 2 9.1195 10.7822 13.1796 -2.73354 4.12568 -26.6086 -613 1 12.9112 1.40899 13.3219 3.38587 -22.7152 11.6955 -614 2 13.5257 1.21801 12.5994 -2.66679 10.6744 -3.40434 -615 2 12.4724 2.23119 13.1327 -1.22779 13.5514 -6.35015 -616 1 6.39925 13.6301 2.14388 13.7527 -0.778699 -6.56015 -617 2 5.84347 14.0897 2.78318 -1.88549 -3.79567 9.96763 -618 2 7.03431 13.0755 2.63977 -7.58465 4.89894 -0.0461429 -619 1 15.9327 6.56061 12.7538 -0.9836 2.19135 -10.6596 -620 2 16.5146 6.98287 12.103 -5.34808 0.40017 1.48081 -621 2 16.2873 6.8165 13.6112 3.99792 -3.90075 7.11277 -622 1 16.8306 0.705066 9.59578 -7.6122 -1.79623 -7.44488 -623 2 16.785 18.3903 9.75048 3.18156 2.06447 -0.865929 -624 2 16.3719 0.843651 8.74144 5.4764 0.262409 5.10626 -625 1 6.12658 11.6826 8.3633 -3.5227 -13.2845 -7.84739 -626 2 5.19255 11.5559 8.64231 15.2704 -3.4985 -2.63712 -627 2 6.45331 10.8168 8.01189 -8.18375 16.1965 9.35276 -628 1 2.85137 8.68091 0.385463 -5.58051 9.89965 12.0536 -629 2 2.19225 8.31695 18.4611 -2.16592 -25.8024 -20.6889 -630 2 2.2971 9.35613 0.77772 10.4924 10.4953 14.3564 -631 1 10.1291 10.4583 6.52809 -2.44089 1.08082 5.72444 -632 2 10.551 9.78353 7.0828 -0.111445 0.581803 -4.14441 -633 2 10.6952 10.5682 5.75546 0.540532 -2.90301 -3.90698 -634 1 6.75412 15.726 6.57209 -8.13971 -2.30487 -2.02419 -635 2 7.24364 15.9641 7.36655 2.15693 7.18823 -0.87292 -636 2 6.8879 16.4298 5.90744 8.86888 -7.67267 7.00242 -637 1 6.43944 13.0908 5.62507 5.5957 4.80241 6.78236 -638 2 6.68766 13.9873 5.91055 -1.86537 -6.12454 -2.89892 -639 2 6.02344 12.6885 6.39583 0.545895 -2.8305 -0.33431 -640 1 16.7919 12.5477 9.81186 8.33998 7.78307 -15.4118 -641 2 16.959 11.947 9.07064 -2.3739 -7.40637 3.16023 -642 2 17.0566 13.4004 9.43565 -5.48117 -2.43007 10.0621 -643 1 6.08508 2.94496 2.79534 5.32525 -4.78467 20.7365 -644 2 6.22401 3.88181 2.60268 1.06349 -0.160394 -8.38338 -645 2 5.80007 2.47136 2.00522 -4.08992 3.93243 -8.80646 -646 1 10.8869 3.24711 3.28239 -4.40001 1.54122 -3.81905 -647 2 10.3919 4.04182 3.50512 -0.182415 -1.04618 4.274 -648 2 10.507 2.97693 2.43998 1.37333 -6.80979 -0.861155 -ITEM: TIMESTEP -40 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.77679 7.00681 17.9176 19.5781 -11.4355 -6.13067 -2 2 7.88289 7.04978 18.2154 -24.3238 4.20085 7.9494 -3 2 8.82569 6.20257 17.3924 1.80136 1.41546 -3.93969 -4 1 18.6608 8.28849 6.81179 -5.26854 6.47195 -37.0065 -5 2 0.259818 8.10211 5.87223 -9.20216 6.37217 14.1473 -6 2 0.533966 7.65898 7.28863 11.4703 -14.4857 21.9358 -7 1 8.44459 18.6539 6.84319 -15.0888 3.44445 3.75329 -8 2 9.31627 0.207433 6.52222 15.1831 4.47029 -4.67038 -9 2 7.87035 0.688968 6.45696 3.7806 -3.44044 1.26969 -10 1 6.57294 1.78151 11.6706 -30.0599 9.45416 18.0529 -11 2 5.79693 2.24632 12.0928 24.7239 -13.8096 -10.3139 -12 2 6.23894 0.879353 11.5248 3.88204 4.12095 -2.29502 -13 1 7.0611 5.68864 2.39703 8.93877 -14.6422 -9.86735 -14 2 6.49127 6.20844 2.93802 -15.3109 10.2002 23.1803 -15 2 6.88849 6.05122 1.53455 1.63853 6.11013 -15.8751 -16 1 16.2018 10.2111 16.0976 42.0151 -2.30245 8.02011 -17 2 17.1767 10.3828 16.1846 -31.1897 -9.90141 -8.38467 -18 2 15.8087 11.0308 16.3852 -12.3763 9.98735 1.02793 -19 1 10.6387 14.9527 2.33657 9.03987 18.5511 -2.17595 -20 2 10.545 14.5243 3.1949 1.96881 -4.62445 -0.461144 -21 2 11.2262 15.72 2.53493 -10.4825 -13.512 -5.5858 -22 1 17.1607 8.25027 10.5569 -10.4361 3.90862 15.3578 -23 2 16.8456 8.92829 11.1924 -0.168965 -8.85021 -9.39988 -24 2 17.9277 8.63713 10.1294 7.74511 3.00226 -1.55375 -25 1 14.7566 15.8542 16.4215 -9.50848 16.8449 -9.38304 -26 2 13.8265 16.1715 16.4278 14.8795 -5.02546 -3.6071 -27 2 14.9162 15.569 17.3232 -2.48975 -11.4773 7.52297 -28 1 12.1331 13.4103 0.48985 -10.556 -4.43922 -13.5861 -29 2 11.9475 13.3795 18.1761 8.0664 -0.863413 7.07636 -30 2 11.3865 13.8946 0.862316 6.65844 3.98247 10.4433 -31 1 9.29843 5.44761 4.00486 3.37284 8.34248 -28.0116 -32 2 8.80378 5.24143 4.78809 -8.97197 -9.15203 12.3932 -33 2 8.61542 5.51114 3.30134 8.62356 -3.76178 8.99247 -34 1 1.79678 4.17189 11.6321 9.86643 -30.5991 16.8051 -35 2 1.62878 5.09135 11.8205 -3.04918 18.6361 6.49963 -36 2 2.25792 3.77365 12.4221 -11.5809 11.2089 -24.12 -37 1 2.02425 6.80455 8.32417 0.209126 8.78432 0.0974623 -38 2 2.41895 7.33028 9.04952 -2.4595 -11.9319 -6.9206 -39 2 1.91003 5.89259 8.64365 4.06316 7.1017 -1.03524 -40 1 5.41039 4.42866 7.97545 15.1976 -3.31539 14.1613 -41 2 5.46063 3.46886 7.81834 -3.32316 3.28084 -1.43066 -42 2 4.8072 4.83488 7.36206 -13.6118 -1.04066 -17.9483 -43 1 3.27942 2.94296 17.507 14.649 -12.38 -13.2068 -44 2 4.01307 3.22765 16.9192 -12.2988 4.29907 8.19647 -45 2 2.92414 3.72569 17.9407 -4.7152 6.06254 1.98711 -46 1 7.44402 5.32718 6.09908 -2.23439 -3.56175 -18.7368 -47 2 8.08992 5.98284 6.3762 -3.15187 6.11466 20.9447 -48 2 6.88688 5.06352 6.84221 3.51936 -1.39652 7.32666 -49 1 9.78623 6.99393 11.9838 -8.59529 -1.09594 -12.3674 -50 2 10.3445 6.45759 11.4052 1.55365 1.23763 7.43723 -51 2 9.00985 7.18223 11.4209 7.62587 2.79809 7.26056 -52 1 14.0725 3.61727 8.08367 12.8617 -8.18347 36.7285 -53 2 14.0228 4.31343 7.45005 -3.4794 19.1063 -13.5046 -54 2 14.4179 4.02628 8.91908 -9.29791 -10.4076 -21.8094 -55 1 4.59231 17.2384 3.97449 0.493238 3.33808 0.649061 -56 2 5.51414 17.4776 4.03994 12.0557 0.622386 5.90157 -57 2 4.23063 17.8039 3.28947 -7.41249 -4.06804 -9.31956 -58 1 16.4721 16.5989 10.1846 -15.657 14.3962 29.6607 -59 2 15.672 16.8273 10.736 23.5631 -12.0212 -18.4682 -60 2 16.1719 15.9965 9.50314 -9.75188 -3.46964 -7.56259 -61 1 1.98052 4.85246 0.373619 -1.44601 4.98585 -7.77412 -62 2 2.7262 5.17853 0.894803 -2.15831 4.7879 6.78517 -63 2 1.59165 5.65237 -0.0264377 4.8265 -6.05414 -1.09652 -64 1 11.6431 13.3034 16.3099 -7.83069 14.4437 11.7005 -65 2 11.0472 12.5464 16.386 4.77345 -10.1552 -4.34879 -66 2 12.2516 13.1635 15.5747 -3.53477 -7.02177 -5.05796 -67 1 10.1531 11.0326 16.9094 -23.9188 11.6521 -2.01913 -68 2 10.5087 10.1543 16.8125 9.70699 -14.9542 1.17008 -69 2 9.18648 10.9213 16.8155 11.1855 0.742098 0.22461 -70 1 11.7413 17.4552 13.4621 -1.23374 28.315 3.5075 -71 2 12.4767 17.2116 12.8888 0.8966 -9.51431 -5.30227 -72 2 11.7922 18.439 13.4864 2.17346 -17.034 -0.823798 -73 1 6.40572 9.32656 12.214 8.55802 19.8904 20.5686 -74 2 6.90308 8.91303 11.5283 8.82473 -10.1612 -21.9185 -75 2 7.05175 9.94906 12.6124 -18.2049 -7.77814 -0.199089 -76 1 16.2334 12.8098 2.68826 14.0272 -12.5996 -1.63763 -77 2 17.097 13.226 2.50419 -12.4159 2.28924 0.929092 -78 2 15.5495 13.4898 2.7216 0.770652 8.50493 2.13384 -79 1 0.665645 12.593 5.91595 32.2246 4.40393 3.59492 -80 2 0.90587 12.5095 4.99041 5.40697 -3.98614 -5.66175 -81 2 18.3758 12.6087 5.91046 -34.4951 5.63016 -3.48792 -82 1 5.23151 16.431 18.4431 -16.7943 8.81872 -4.95242 -83 2 5.79594 15.7593 18.0508 10.3373 -8.32481 3.89376 -84 2 5.47944 16.6222 0.707356 8.36178 -5.19521 1.40492 -85 1 0.571414 7.67431 4.12619 2.94709 1.59491 -2.60127 -86 2 18.6158 8.07004 3.46977 2.09916 -2.88444 -0.00351913 -87 2 1.46322 7.94524 3.84829 -2.55586 0.342718 0.201417 -88 1 3.11705 8.93424 6.4998 54.1901 -7.8337 2.25484 -89 2 3.7667 8.5317 7.12157 -13.167 10.549 -15.4875 -90 2 2.28764 8.76575 6.88741 -36.769 -1.96533 12.6863 -91 1 7.28047 10.3297 16.2671 12.2744 -1.5589 -10.8048 -92 2 6.65751 10.5384 15.5688 -5.93087 0.719661 3.96859 -93 2 6.78418 10.1979 17.0822 -4.65586 3.14184 2.44827 -94 1 11.1311 1.01006 5.00872 -4.59838 3.25637 13.1063 -95 2 11.104 1.87564 4.56859 3.00456 -5.57579 -4.19999 -96 2 10.7195 0.375584 4.41788 -1.87117 -0.379426 -13.1931 -97 1 4.37947 2.77237 13.219 1.2209 -0.528365 -1.66794 -98 2 4.72737 3.08878 14.0495 2.85744 14.0767 5.60955 -99 2 4.20383 1.85536 13.4394 -3.83295 -12.6961 -6.71285 -100 1 8.38383 10.1509 1.80871 -12.6182 20.2791 -9.41543 -101 2 8.178 10.838 2.47049 7.2019 -6.44506 -5.42193 -102 2 8.73482 9.42727 2.30684 9.9898 -17.6863 11.9989 -103 1 10.4319 1.72481 15.5562 12.4011 -4.85254 7.43664 -104 2 11.3895 1.56158 15.4091 -17.4954 3.73262 -0.131687 -105 2 10.062 2.13812 14.7716 6.37582 -0.463351 -11.2945 -106 1 2.70803 12.8564 7.7877 0.947466 12.6679 0.63847 -107 2 3.18684 13.6562 7.51328 0.350127 -6.04869 0.642024 -108 2 1.99719 12.778 7.13709 0.576803 -6.26493 0.417134 -109 1 3.70343 11.6943 5.19413 20.2082 20.004 0.0632986 -110 2 3.58824 10.8286 5.55511 -6.2763 -16.1433 9.0068 -111 2 3.08304 11.8089 4.48497 -14.3756 -1.22762 -7.56914 -112 1 6.79775 14.44 16.9261 12.4025 3.68508 -3.36544 -113 2 7.76361 14.3574 16.912 -9.58328 3.53086 0.838276 -114 2 6.54478 14.7426 16.0399 -3.94857 -4.38541 1.40645 -115 1 14.2011 14.5459 3.3522 -3.08566 -2.84615 -1.00806 -116 2 13.6596 15.3308 3.14384 3.83224 -9.07839 4.89455 -117 2 13.7292 13.9763 3.99269 1.14293 11.3016 -6.48612 -118 1 8.39096 18.1361 16.0337 -32.316 13.1552 1.22555 -119 2 8.83502 17.3455 16.3332 22.4875 -6.85104 -0.859562 -120 2 8.9267 0.219511 15.6905 18.196 -4.39201 7.01778 -121 1 4.72714 1.63535 4.92703 -26.6842 -20.3158 26.1173 -122 2 3.8064 1.92851 4.99525 4.72714 3.40068 -1.69015 -123 2 5.07003 2.08002 4.18139 17.9323 21.4409 -28.6349 -124 1 14.9964 12.7123 16.4352 -4.22015 -14.1687 -30.4934 -125 2 14.5029 13.21 17.0522 -6.30453 18.4993 32.9687 -126 2 14.3164 12.5754 15.7407 23.1427 -3.84454 1.0347 -127 1 15.7385 18.4508 16.8675 -13.9243 -22.2803 -23.7862 -128 2 16.4074 18.4637 17.529 20.9098 4.79862 21.1737 -129 2 15.5806 17.4953 16.7298 -7.09236 11.271 1.12369 -130 1 1.21817 1.19055 16.5653 11.7565 -7.97186 -17.2906 -131 2 1.96844 1.77109 16.7379 1.96571 4.11248 6.40071 -132 2 0.658106 1.26508 17.3256 -9.62795 7.29392 16.1709 -133 1 18.134 4.50826 15.9251 -3.15057 6.2034 16.9599 -134 2 18.3539 4.06683 15.1192 3.29697 -9.24478 -15.9855 -135 2 0.215105 4.3469 16.5346 0.451532 1.5183 -0.00159427 -136 1 12.2559 16.9635 16.13 9.81693 16.417 -30.969 -137 2 11.5335 16.7255 16.6761 -27.6315 -15.1383 17.2649 -138 2 11.8852 17.008 15.2138 11.4543 -2.176 15.2032 -139 1 16.0072 2.53826 18.0715 2.86853 -7.51147 -8.26075 -140 2 15.4847 3.23875 18.4474 -1.55266 16.6686 8.62869 -141 2 15.8031 2.59593 17.1292 0.710765 -2.58084 -2.04371 -142 1 6.70782 13.8427 10.2201 -0.679857 -3.70625 -19.7607 -143 2 6.50134 13.5235 11.1067 -0.321862 -5.5215 0.0793921 -144 2 6.59662 13.1168 9.5703 -2.40279 4.60459 14.5526 -145 1 10.136 18.3381 2.74267 -18.0567 -22.0341 20.6824 -146 2 10.1719 0.451126 2.17508 1.85432 15.9621 -15.8725 -147 2 9.21984 17.9907 2.65838 20.6262 7.0183 -5.07627 -148 1 3.02443 17.7208 6.1026 17.1013 10.0229 -4.66436 -149 2 2.15568 17.711 5.71196 -13.0363 -3.14036 -7.80794 -150 2 3.59824 17.9918 5.35649 -4.18715 -9.59785 14.6662 -151 1 12.576 16.8948 8.01086 19.6337 5.92584 -6.52436 -152 2 11.8143 16.3513 7.79321 -8.3204 -4.9503 8.18666 -153 2 12.4158 17.4227 8.81259 -8.93553 -1.00079 -7.85288 -154 1 14.8883 15.2954 8.22088 18.3997 -23.9506 8.44323 -155 2 14.185 15.9366 8.136 -10.7922 9.32905 -8.87486 -156 2 15.3949 15.2296 7.38647 -11.857 13.9652 6.76292 -157 1 17.682 18.2494 0.348905 -7.91474 13.422 2.87656 -158 2 18.5411 17.7865 0.321045 -1.05993 10.3639 -2.93184 -159 2 17.7527 0.554981 0.612143 9.7328 -21.6142 -4.56589 -160 1 0.864553 10.4271 1.36107 38.8853 37.5027 -14.379 -161 2 0.108953 9.99831 1.68821 -41.9718 -23.1906 9.82059 -162 2 0.582253 11.2112 0.83245 0.481516 -18.0373 9.72219 -163 1 1.69239 12.2275 3.35367 -4.8948 -13.153 3.57872 -164 2 1.37753 11.4769 2.79371 7.82838 19.3971 -0.83705 -165 2 1.72119 13.0511 2.84994 -1.71551 -5.72989 -9.02345 -166 1 0.593488 17.2339 4.88925 5.54216 -9.27995 13.1842 -167 2 18.6577 17.9974 4.73698 -0.720643 -6.26101 15.0882 -168 2 0.46443 16.7935 5.76992 -5.72363 16.5902 -22.8723 -169 1 1.11371 0.949119 9.43078 -14.7072 -12.8067 -15.4602 -170 2 1.29442 0.455313 10.245 -0.545661 8.99323 2.98013 -171 2 0.250893 0.599212 9.12975 16.3522 9.05079 5.79158 -172 1 16.7438 2.34594 13.2927 -5.57812 -16.9062 26.8121 -173 2 16.8801 2.6271 12.4058 4.66444 4.54161 -27.0891 -174 2 16.4868 1.39796 13.2842 6.06262 14.3342 0.102967 -175 1 2.62374 15.8311 12.1325 -18.0747 14.04 -25.4855 -176 2 3.15014 15.3809 12.7666 13.9506 -11.3972 18.0386 -177 2 3.07511 15.7224 11.2774 1.07994 -2.68321 4.96368 -178 1 16.4243 15.6576 6.03755 15.9104 -4.34147 -2.36376 -179 2 17.3476 15.7161 6.33483 -8.235 -6.85341 4.18965 -180 2 16.3427 16.413 5.44101 -7.92512 0.157724 -1.18513 -181 1 5.79129 5.09168 11.8004 -4.72983 -0.0241771 3.34223 -182 2 5.24592 5.67928 12.3598 8.87085 -1.40185 -4.45321 -183 2 5.33436 4.24005 11.794 -1.89173 5.24027 0.81451 -184 1 15.1611 4.86757 0.757741 -10.8083 7.02962 -6.60621 -185 2 15.185 4.56786 1.66832 -2.59424 -2.50065 9.27943 -186 2 14.3347 5.37902 0.687967 11.9305 -6.73266 -3.44958 -187 1 16.3215 16.3801 2.08305 3.66808 -22.0917 28.3334 -188 2 16.2883 16.7145 3.0131 -8.2177 -1.24054 -23.9705 -189 2 16.5228 17.1161 1.52724 6.03518 21.1991 -10.8898 -190 1 0.258418 4.84833 3.80491 9.83943 -33.1452 17.0376 -191 2 0.435143 5.7654 3.92096 2.60191 31.4745 -0.643169 -192 2 0.932226 4.39489 4.35318 -12.3014 6.6918 -13.6862 -193 1 2.96829 15.0617 15.1396 -6.44278 -4.84309 -5.22724 -194 2 2.79942 14.7982 16.0602 -0.108783 -2.99279 -5.19286 -195 2 2.41643 15.8476 15.0194 7.7594 2.37019 3.88633 -196 1 1.13965 14.6405 9.53256 -35.9747 -40.3241 22.6064 -197 2 2.06314 14.7027 9.49112 43.1319 12.9068 -8.07313 -198 2 1.0594 13.7772 10.0119 -9.44904 20.5678 -15.2205 -199 1 13.5675 16.5961 11.5382 5.93785 -23.7105 -2.52771 -200 2 13.3768 17.2545 10.8786 -7.41053 16.3631 -3.48345 -201 2 13.1856 15.7884 11.1314 1.00946 8.65797 10.7521 -202 1 4.66618 1.4643 0.77663 11.7421 5.19522 -12.5382 -203 2 4.19094 2.00712 0.127209 -4.75679 -3.07286 5.52347 -204 2 4.08138 0.751582 1.04859 -6.60629 -1.36494 5.43578 -205 1 1.44472 18.5589 11.8552 5.89014 -29.5111 2.70443 -206 2 1.28184 0.411827 12.6654 0.0657759 4.1157 4.72514 -207 2 1.66959 17.6355 12.1243 -0.811151 21.0135 -2.36357 -208 1 11.5239 10.1243 4.0099 -6.2394 6.26334 5.03821 -209 2 11.225 10.535 3.18075 6.07738 -4.97061 3.39644 -210 2 12.4891 10.1836 4.01184 1.61922 -2.52467 0.807021 -211 1 8.27885 12.1614 3.71144 8.13123 -6.41358 -26.5436 -212 2 9.10665 12.5897 3.97429 -2.42085 2.52867 6.94663 -213 2 7.68553 12.1691 4.45091 -10.6399 7.25218 24.1014 -214 1 14.4389 4.03262 3.28382 -1.54769 2.04788 0.687462 -215 2 14.9998 3.98927 4.07922 -0.140352 3.9435 -3.93632 -216 2 13.6855 4.60992 3.49399 3.24138 -5.01437 4.30138 -217 1 5.6049 1.66195 7.51556 2.43321 19.3851 -35.7094 -218 2 4.99817 1.05358 7.93111 -11.2062 -8.09843 6.71806 -219 2 5.29033 1.73413 6.56196 15.7086 -7.98236 30.9511 -220 1 17.8679 1.11465 4.8662 -8.84521 -11.3875 -0.414623 -221 2 18.5938 1.34898 4.28573 7.92092 9.45731 -1.66923 -222 2 17.9348 1.63294 5.67672 2.41874 4.31495 -1.38437 -223 1 6.82183 9.41821 4.49596 0.331068 -0.81956 4.69879 -224 2 6.92763 9.68813 5.42975 0.55668 -5.9518 -10.6641 -225 2 7.69076 9.13696 4.17138 2.49623 1.53594 7.84385 -226 1 2.6692 14.9191 1.96889 -13.7427 -15.0981 33.3863 -227 2 3.22272 14.7135 2.75628 -3.53882 5.4164 -17.9931 -228 2 3.23582 15.271 1.30455 16.0902 7.51076 -16.3339 -229 1 17.3236 12.914 13.1856 6.20451 10.459 -3.7314 -230 2 16.5162 13.3803 13.3896 -16.2035 -4.78456 4.03007 -231 2 17.8657 13.6659 12.9192 5.22743 -7.26423 -1.93052 -232 1 14.957 10.5619 1.40158 33.4378 15.8576 14.4167 -233 2 15.5687 11.2535 1.77718 -16.3935 -17.8486 -10.6273 -234 2 14.0947 10.9454 1.47451 -15.7071 3.57407 -1.68856 -235 1 5.70225 6.80052 4.56184 6.57688 14.9147 -7.26545 -236 2 6.13296 7.68472 4.64206 -12.0226 -12.483 -2.28626 -237 2 6.28869 6.17268 5.00191 2.5554 2.13057 5.94298 -238 1 8.01258 8.29623 10.2593 -8.54796 -9.21297 9.02749 -239 2 8.56841 9.06789 10.0886 3.62647 -1.62136 -15.6888 -240 2 7.62542 7.94814 9.4343 7.03713 6.69092 4.95874 -241 1 13.441 18.4149 5.75957 4.19405 2.302 -13.2138 -242 2 12.6243 0.255994 5.52243 8.89948 -2.22339 5.88848 -243 2 13.1991 17.7887 6.44621 -5.69407 0.108635 9.70575 -244 1 0.157493 2.61527 0.174457 -9.01339 -22.8294 -0.321401 -245 2 17.938 2.88173 18.4446 6.58659 5.28303 7.29983 -246 2 0.732894 3.35773 0.380844 -2.17088 12.8237 -3.11298 -247 1 12.7457 11.0391 9.7485 36.4778 -29.6492 25.4167 -248 2 11.881 10.9734 9.40839 -39.1103 -1.43989 -11.0388 -249 2 12.9187 10.1217 10.0968 -0.290925 20.2268 -9.99681 -250 1 0.740308 12.1745 11.0603 -22.9837 8.27774 -1.01284 -251 2 18.4139 12.2368 11.1424 7.83285 -3.43363 -6.48653 -252 2 1.04445 12.5328 11.8929 13.1768 -0.7817 9.81141 -253 1 5.09631 7.29496 13.4329 -5.02176 -6.40528 2.12919 -254 2 5.65923 7.87015 12.9013 0.281799 7.42737 5.37855 -255 2 5.54275 7.21467 14.2893 3.22018 -2.41867 -5.38403 -256 1 1.21307 6.88521 11.8471 45.2055 23.2855 19.4361 -257 2 0.504281 7.33909 11.418 -17.6401 7.5893 -9.966 -258 2 1.85566 7.62216 12.1147 -28.9146 -29.9066 -6.84092 -259 1 15.4951 9.58282 12.318 3.7565 -9.08444 -2.54037 -260 2 14.9885 10.3731 12.1762 -1.60608 19.4691 -5.65324 -261 2 15.197 9.26603 13.1641 1.66558 -4.92983 10.8479 -262 1 16.5876 12.7654 5.4778 8.29992 -4.99789 29.9812 -263 2 16.3841 13.7077 5.58453 -1.61151 1.51391 -8.42869 -264 2 16.4534 12.5134 4.57091 -6.79319 5.2662 -20.9737 -265 1 6.24519 9.93185 0.0511849 19.8307 -8.34124 26.5163 -266 2 5.62326 10.391 0.623031 -8.96333 4.37615 -1.09153 -267 2 7.04636 9.86115 0.632167 -14.2701 4.68407 -14.2447 -268 1 12.3094 6.10151 4.07154 29.4526 9.60181 -18.9544 -269 2 12.3581 6.67925 3.27122 -7.72489 -2.14158 19.4346 -270 2 11.4533 5.70734 4.07903 -24.5921 -5.49884 -2.8127 -271 1 0.238725 12.7856 0.183979 8.51406 3.08383 0.253195 -272 2 0.144933 13.4932 0.833619 -6.86037 1.22763 2.8825 -273 2 18.4214 13.096 18.0418 -3.66036 2.31192 -5.9902 -274 1 3.70956 18.598 8.57987 -8.91795 8.796 11.4474 -275 2 3.55449 18.0356 7.80833 -3.96611 6.10323 -0.149317 -276 2 2.8446 0.378518 8.78385 11.2365 -8.2841 -4.38951 -277 1 7.48876 17.3305 4.49636 -9.17434 -25.7083 -0.449464 -278 2 7.67261 18.2518 4.49855 7.01126 32.4538 5.60223 -279 2 7.56532 17.0943 3.57389 -1.71949 -1.63571 -7.00131 -280 1 9.24209 17.1007 12.2607 -0.0867103 -4.31389 -13.5747 -281 2 9.30622 16.4126 11.5797 -4.40084 -0.983353 3.37399 -282 2 10.1228 17.1279 12.6444 4.44927 1.46684 7.86514 -283 1 13.3362 12.9421 7.98122 6.55916 41.1429 -16.6734 -284 2 13.3796 12.1892 8.55526 4.57885 -11.5398 14.8452 -285 2 13.9495 13.647 8.31623 -8.21726 -16.9651 -6.13203 -286 1 14.9343 2.98184 15.3399 -18.8859 -3.08059 15.3623 -287 2 14.3306 2.22694 15.2091 8.05839 6.56319 -1.64083 -288 2 15.5611 2.99492 14.6188 6.00199 -3.60128 -9.94013 -289 1 9.8611 15.5568 16.9864 -5.18568 1.15062 7.50023 -290 2 10.3014 14.7282 16.7357 2.8278 3.85059 0.776615 -291 2 9.42894 15.4199 17.8518 3.24739 -0.30663 -9.25648 -292 1 11.3089 8.34774 16.5637 -8.99518 -4.25182 3.40254 -293 2 10.6351 7.93491 15.9913 5.93093 -1.15278 9.90769 -294 2 11.3777 7.78039 17.3602 -0.876032 6.75541 -11.8921 -295 1 3.86263 18.1743 16.7605 8.31608 -24.0238 3.67333 -296 2 4.34809 17.526 17.3016 -5.03788 -1.4921 -11.4176 -297 2 3.91859 0.291346 17.3034 -3.84782 28.4328 8.21839 -298 1 2.18675 4.1526 8.92206 -24.1698 7.19476 -17.4672 -299 2 3.08777 4.02084 8.66345 19.2563 -3.88604 2.84364 -300 2 2.11989 4.14607 9.87269 6.11123 -7.11558 17.6044 -301 1 9.878 10.3743 9.69372 5.53967 -18.4491 14.0185 -302 2 9.43572 11.1423 9.3425 -1.35277 14.796 -0.820696 -303 2 10.0526 10.4842 10.6451 0.294207 2.81912 -6.3598 -304 1 9.67606 0.861397 10.8616 12.1631 -0.119776 7.34561 -305 2 9.24662 0.0503119 11.2005 -2.60905 7.79605 -9.27605 -306 2 9.17358 1.27941 10.1433 -7.66403 -7.87567 2.43043 -307 1 9.19351 15.1133 10.2188 11.11 2.94282 0.236533 -308 2 8.72034 15.7288 9.64731 -2.95318 7.0206 -0.021652 -309 2 8.61234 14.3559 10.3013 -9.273 -0.749783 0.810803 -310 1 0.983709 9.49699 10.2982 -74.1988 19.4185 4.2569 -311 2 0.893433 10.4494 10.5162 13.7438 -13.7231 -2.84852 -312 2 1.86549 9.26486 10.2468 58.3196 -6.52918 -3.90093 -313 1 16.9084 4.83943 8.1598 4.06942 21.6595 -28.8412 -314 2 16.3724 5.61591 8.36865 -1.41178 -4.09344 3.51719 -315 2 16.8393 4.26054 8.89216 -0.699807 -17.3102 23.1105 -316 1 14.7125 14.7098 0.257213 21.3866 7.73012 -2.74727 -317 2 15.2455 15.0698 0.987096 -5.24332 1.02996 -2.3964 -318 2 13.934 14.3364 0.654485 -15.8904 -6.61515 6.72623 -319 1 3.61962 11.0361 9.55343 7.54802 -1.42323 12.4812 -320 2 3.62776 11.3571 10.4773 -0.544226 1.54555 -6.56144 -321 2 3.18313 11.7186 9.01674 -3.18494 -0.813089 -1.4949 -322 1 11.1481 10.7794 1.3867 -18.0125 -13.9714 2.13506 -323 2 11.5419 11.6189 1.17487 5.50703 16.2749 -10.1623 -324 2 10.2377 10.7815 1.02242 13.9743 0.382042 6.15217 -325 1 13.1644 7.14571 12.7934 28.1674 11.2254 -0.0108115 -326 2 14.1505 7.05998 12.7803 -16.3048 -3.53009 2.57838 -327 2 12.835 6.25234 12.9024 -6.40061 -9.363 -1.95696 -328 1 9.62034 1.87073 0.979069 -6.9897 -0.645983 -14.1021 -329 2 8.86926 1.41829 0.528843 9.90899 13.9476 5.87182 -330 2 10.1257 2.37739 0.312436 -3.40486 -11.198 4.68953 -331 1 10.6367 13.5403 4.62088 -14.2461 -11.7796 -9.34504 -332 2 11.3649 12.9086 4.64313 9.4379 4.41524 3.81629 -333 2 10.614 13.9519 5.48444 4.98914 7.07 10.6976 -334 1 14.3951 1.77229 10.9373 11.882 -13.8992 0.14286 -335 2 15.2529 1.46692 10.5904 -8.80209 -5.09491 0.192719 -336 2 14.4998 2.72321 10.9422 -3.89457 8.74507 -1.42899 -337 1 14.6035 12.2778 11.6732 8.28457 -2.47972 34.5189 -338 2 15.3822 12.4706 11.1386 -1.8445 -1.29245 -12.2333 -339 2 13.8238 12.1274 11.1597 -9.6117 -2.29221 -24.4043 -340 1 8.21682 5.05944 9.82725 33.2235 -12.7421 -22.1109 -341 2 7.50249 5.31613 10.3805 -26.8995 -2.6371 14.604 -342 2 8.16278 4.09579 9.61432 -6.39419 19.305 4.57693 -343 1 1.57178 16.8746 18.3696 -12.5949 -28.7752 19.8992 -344 2 1.95856 17.2997 17.6256 12.4489 12.7929 -23.944 -345 2 1.61191 15.9133 18.1414 3.74732 18.7705 7.54273 -346 1 1.50483 17.2622 15.3369 -31.2805 -0.211241 0.372367 -347 2 1.56428 18.1715 15.7008 -8.02099 -13.4799 -3.86937 -348 2 0.550545 16.944 15.3287 29.8388 16.9503 2.40621 -349 1 3.67189 5.70682 6.10259 2.52977 5.35962 -6.45813 -350 2 3.10512 6.24939 6.65687 -5.8484 1.84291 7.09291 -351 2 4.11645 6.33532 5.504 1.86189 -8.61654 4.18176 -352 1 12.4205 9.46682 14.1922 0.00765934 6.29699 5.01976 -353 2 12.7713 8.66673 13.7826 1.27338 -5.49384 -0.333278 -354 2 12.2037 9.20626 15.0998 2.51081 -2.42178 -0.168732 -355 1 4.04257 15.2822 6.8914 -27.6779 4.92775 8.06061 -356 2 3.56316 16.0906 6.63798 2.42102 -8.57509 -1.16647 -357 2 4.95231 15.5118 6.77617 25.3206 1.78005 -4.31003 -358 1 0.630616 8.59357 14.9621 0.0534875 13.3347 6.63524 -359 2 0.475879 9.54739 15.0951 0.802494 -5.58418 -0.636111 -360 2 1.32488 8.5708 14.2996 4.58301 -1.27906 -6.75903 -361 1 12.9988 8.28033 10.3217 -21.3611 19.4324 1.5895 -362 2 13.6573 7.74741 9.88515 12.8548 -10.016 -2.83384 -363 2 12.9714 7.9897 11.246 0.968107 -4.04745 -5.09921 -364 1 15.3184 7.7322 3.54707 4.18654 -9.90345 10.9868 -365 2 14.6375 7.17364 3.22195 -21.9236 0.488691 -25.4272 -366 2 15.542 7.2045 4.31452 16.9904 15.0521 14.7627 -367 1 17.298 6.68564 0.0426033 13.9193 -14.0885 -0.920406 -368 2 16.8642 5.82471 0.139777 0.0396094 5.05794 2.76644 -369 2 16.6003 7.28204 18.4358 -17.9105 11.3609 -4.38582 -370 1 8.85442 6.93876 7.83202 25.5204 20.9839 -12.9835 -371 2 9.78415 7.28149 7.87459 -21.3181 -5.86923 -3.23496 -372 2 8.81067 6.25344 8.49096 -5.61401 -13.4392 14.4413 -373 1 12.3763 0.596552 1.22002 -1.17453 2.99561 6.82033 -374 2 13.3385 0.528874 1.30915 -5.26207 -0.953155 0.827968 -375 2 12.0852 0.273415 0.369127 5.54968 -2.26078 -4.64309 -376 1 5.63283 15.1348 14.5573 -11.4131 -7.08845 -3.56826 -377 2 4.66833 15.2302 14.6984 9.61439 -4.03287 3.27369 -378 2 5.92452 15.9751 14.1944 7.77409 8.39082 -1.96781 -379 1 3.86657 6.44559 1.75085 5.80409 -14.6499 1.98717 -380 2 3.55249 7.31671 1.4889 -5.45171 9.45984 0.647045 -381 2 4.14269 6.4981 2.68117 -5.39897 6.08822 -6.8935 -382 1 3.91507 11.6157 12.3486 -13.4135 -1.42429 5.74998 -383 2 4.7693 12.0145 12.538 6.44699 -0.479912 -1.2837 -384 2 3.27735 12.1325 12.8813 7.77399 -7.15276 -11.5357 -385 1 5.36262 3.86651 15.8768 12.1389 -59.3419 -3.52329 -386 2 6.1064 3.19888 15.7551 -26.8485 22.8054 1.66706 -387 2 5.75212 4.71249 15.8089 15.627 34.646 -1.2618 -388 1 14.3819 10.2457 4.44716 -17.5064 5.46907 41.0935 -389 2 14.5449 9.71992 5.26671 -1.94493 10.8322 -14.5796 -390 2 14.8723 9.82528 3.76702 14.2142 -16.5996 -23.0963 -391 1 7.82031 17.402 9.18196 15.4978 -20.6961 5.52716 -392 2 6.95708 17.6159 9.5372 -6.73409 6.75657 -1.79958 -393 2 8.0438 17.9374 8.41052 -8.48575 5.6988 -1.01071 -394 1 4.52697 14.5011 3.99561 -1.64824 1.80571 -15.4173 -395 2 4.43911 15.4257 4.28139 2.0309 -4.99506 3.13673 -396 2 4.3827 13.9072 4.73582 -0.0495062 -0.930109 11.2178 -397 1 14.2192 7.41869 15.785 -17.5888 -3.59777 -10.979 -398 2 15.1626 7.35697 15.6947 20.631 -1.7403 -3.62609 -399 2 14.073 7.80524 16.6426 0.667235 5.42077 11.7037 -400 1 2.9565 18.2605 1.91108 1.19197 -18.909 -26.3864 -401 2 2.43337 17.7432 1.2423 11.354 8.34367 16.4878 -402 2 2.37308 0.276014 2.2689 -15.3488 13.3111 9.03739 -403 1 8.00359 1.60253 4.55907 -38.5212 -7.91491 7.83452 -404 2 7.38229 2.10405 3.99193 12.1921 -3.74558 1.60605 -405 2 8.88232 1.74243 4.26439 24.0023 10.0694 -13.3902 -406 1 2.4736 14.1336 17.6839 19.5549 7.85258 6.07398 -407 2 1.90347 13.5339 18.1719 -6.00167 -6.95039 -0.586477 -408 2 3.38553 13.9045 17.9683 -9.72011 -2.72883 -0.373401 -409 1 0.820064 1.73894 13.8888 -18.5285 5.33114 2.4032 -410 2 0.803771 1.49328 14.8397 -2.66487 6.43341 -16.8821 -411 2 18.5531 2.02517 13.6233 21.0072 -9.49287 13.5993 -412 1 4.44957 0.0409644 13.9204 -25.6038 8.03756 8.31677 -413 2 5.34611 18.3721 13.8825 17.1601 -8.5878 1.82821 -414 2 4.09536 18.4705 14.8092 8.9848 -0.155186 -10.4675 -415 1 7.11939 0.665063 18.3496 37.4596 -16.3367 -22.9959 -416 2 7.39046 0.248229 17.4868 -7.59422 10.3961 22.0522 -417 2 6.17976 0.73857 18.3349 -24.6121 7.91301 3.99406 -418 1 16.0679 18.4255 14.0033 46.948 4.07246 14.5496 -419 2 15.1925 18.2569 13.7481 -41.7006 -8.82757 -2.39817 -420 2 16.1514 18.46 14.9783 -11.5795 5.15321 -10.1321 -421 1 10.0899 4.51466 16.2755 46.1692 31.6348 -9.79269 -422 2 11.0262 4.80528 16.0633 -26.3332 -3.27592 13.4521 -423 2 10.217 3.58436 16.3451 -11.2214 -29.3564 0.661634 -424 1 15.916 17.7977 4.41903 32.6965 1.49817 -6.30174 -425 2 16.457 -0.0326327 4.45612 -4.70593 -7.03645 1.74937 -426 2 15.0663 18.0576 4.73092 -30.5769 8.16516 8.13282 -427 1 7.01211 17.4116 13.808 -11.1093 -0.0306798 -7.53718 -428 2 7.48321 17.731 14.5797 1.71822 -1.35338 6.01299 -429 2 7.70771 17.2257 13.1599 -0.832239 2.47859 1.40448 -430 1 13.2731 6.49483 6.63036 5.49864 12.0855 21.8831 -431 2 14.0036 7.1367 6.53142 -6.95912 -13.4785 -6.50558 -432 2 12.9191 6.26998 5.7719 1.78547 5.07661 -13.1828 -433 1 7.78873 2.35817 9.26787 13.6578 7.92928 32.9359 -434 2 7.26595 2.28464 10.098 4.41261 -4.66671 -14.4408 -435 2 7.24114 2.08424 8.54668 -18.4281 -7.28868 -15.4379 -436 1 15.1807 14.8213 13.6836 12.0158 -14.5979 1.51453 -437 2 15.023 15.1631 14.5679 -5.44227 3.64048 5.06686 -438 2 14.7818 15.3898 13.0312 -8.03448 9.52233 -3.65179 -439 1 9.37687 8.31604 3.76928 5.34304 4.19186 5.02399 -440 2 10.2244 8.59911 4.15846 -6.46746 6.21109 -7.45595 -441 2 9.38739 7.36131 3.86692 -0.369722 -6.10407 -0.56198 -442 1 17.7826 13.5587 16.3931 -18.259 -13.3606 7.93732 -443 2 16.8564 13.2543 16.3515 3.23179 3.05811 2.18424 -444 2 17.7493 14.412 15.956 6.45918 8.6709 -4.68033 -445 1 4.96945 10.6182 2.7671 -20.0352 21.3698 -14.9929 -446 2 5.67156 10.2863 3.30832 14.7689 -7.42384 15.9186 -447 2 4.73305 11.5 3.12196 4.54065 -18.1741 -2.81522 -448 1 3.75186 8.34553 10.1595 -2.54049 11.5371 -18.7835 -449 2 3.83158 9.28658 9.87851 -1.62744 -10.9109 6.60301 -450 2 3.69687 8.33176 11.111 2.12623 4.07512 13.0596 -451 1 16.0105 7.02075 6.14683 -8.93467 17.9282 -2.69417 -452 2 16.8191 7.42843 6.45697 9.04966 6.41713 2.22097 -453 2 16.1641 6.09023 6.1704 3.21598 -21.4167 -2.94797 -454 1 15.1148 7.07457 9.06702 4.51295 -11.3361 21.5265 -455 2 15.7278 7.43111 9.72685 3.64545 -0.886375 -6.04752 -456 2 15.1684 7.6713 8.33808 0.281889 14.352 -20.2518 -457 1 6.32562 13.0044 12.7823 3.64263 -12.4915 -10.2251 -458 2 7.18031 12.5985 13.0233 -9.44077 2.88231 5.28619 -459 2 6.10277 13.6925 13.4113 4.07235 10.5841 12.4872 -460 1 12.13 4.50388 13.0978 -23.9143 -18.2098 -29.5576 -461 2 12.2018 4.66005 14.0386 -4.52664 -3.61945 12.4396 -462 2 11.31 3.95423 12.8708 29.5104 21.9629 17.7949 -463 1 11.3628 8.1671 7.89263 -5.63688 4.26156 -3.21905 -464 2 12.0486 7.63378 7.48497 5.26632 -9.68169 -9.18733 -465 2 11.6596 8.25059 8.79652 3.08614 3.11673 13.4283 -466 1 17.1728 10.8467 7.48683 -9.78257 9.61375 -3.53187 -467 2 17.8082 10.1926 7.21604 13.2987 -16.4259 3.23364 -468 2 17.1151 11.4269 6.71399 -11.2446 1.98681 4.69156 -469 1 5.26156 18.1118 11.0164 11.279 0.780011 3.76881 -470 2 4.63029 17.9037 11.706 -3.79608 -1.61163 6.00067 -471 2 4.75114 18.4846 10.3039 -10.5863 -2.03901 -14.6626 -472 1 7.60927 17.5116 1.80376 -12.2084 0.332405 -16.0787 -473 2 7.73547 16.6894 1.27511 4.49641 20.7738 7.60921 -474 2 7.29137 18.2078 1.17993 10.7818 -15.1152 7.96202 -475 1 1.93242 12.9038 13.5907 -11.1009 -8.62515 -2.91716 -476 2 1.44204 12.3193 14.1878 -0.742257 0.132846 -0.79095 -477 2 2.14259 13.6778 14.1103 6.96653 11.7909 8.84583 -478 1 9.6349 6.79099 14.8483 -7.90933 -4.5792 7.57822 -479 2 9.76837 5.84646 15.0736 0.917781 12.494 -4.6794 -480 2 9.97866 6.97841 13.9703 0.736717 -7.57275 -8.26148 -481 1 15.2733 4.3257 10.7584 -18.0594 -0.89979 -6.45033 -482 2 16.1458 3.96681 10.9687 3.533 12.3702 4.36819 -483 2 14.9475 4.94569 11.4317 15.7147 -3.56113 0.605423 -484 1 11.2438 6.16931 0.179082 0.0277951 -2.16566 -3.90965 -485 2 11.3357 5.30361 18.4317 14.8036 -12.0621 -1.88578 -486 2 10.2956 6.2638 0.1816 -11.5861 14.503 2.02073 -487 1 0.0439986 11.3816 15.0585 -6.49496 4.09431 2.20477 -488 2 18.034 11.5578 14.353 7.75523 3.54925 4.26198 -489 2 -0.111373 12.1024 15.7029 3.25408 -7.01329 -10.5532 -490 1 7.06114 9.23722 7.26386 23.5376 12.3273 -0.106793 -491 2 6.50127 8.56776 7.63843 -10.2441 -19.5548 5.03643 -492 2 7.97426 8.90952 7.38371 -13.166 2.65106 -3.29749 -493 1 18.3483 15.3728 12.3401 -6.10947 1.64082 -0.490965 -494 2 0.640544 15.4003 12.1341 13.3619 2.30286 0.418231 -495 2 17.9315 15.8707 11.6253 -4.70162 -1.66258 -3.35097 -496 1 16.5284 4.37134 5.23872 23.865 15.8443 -24.0922 -497 2 16.795 4.23475 6.13242 -1.17196 -10.8972 27.7735 -498 2 17.3848 4.63349 4.80865 -25.3878 -11.1359 -1.24016 -499 1 17.7266 3.13043 10.7284 -15.1505 -16.4799 -4.03799 -500 2 -0.0205156 3.31599 11.0266 10.8372 -1.61224 -0.261482 -501 2 17.686 2.21262 10.3629 5.98361 15.5222 5.29053 -502 1 12.2768 0.00077952 10.1229 -5.39949 -11.0736 -0.564535 -503 2 11.3994 0.337416 10.3512 -3.44242 -0.519791 1.58275 -504 2 12.8621 0.740723 10.2534 12.1364 13.942 1.61795 -505 1 10.3933 9.78571 12.4371 -17.696 -6.66554 -9.33286 -506 2 11.04 9.8019 13.1479 9.02187 0.111511 2.28178 -507 2 10.1583 8.84624 12.3274 6.95171 5.58218 -0.582165 -508 1 0.583846 2.83323 7.01904 8.81732 -31.8654 7.83245 -509 2 0.599611 3.49885 7.68934 -3.58556 22.6003 9.07619 -510 2 0.952398 2.07883 7.51841 -6.10214 6.37924 -11.0018 -511 1 0.367433 15.2949 6.92522 -4.7012 3.61818 34.4112 -512 2 0.558547 14.7156 7.70153 -1.71176 22.246 -5.06421 -513 2 0.60814 14.7658 6.19753 10.4713 -26.0103 -27.8181 -514 1 17.0409 7.00624 15.2099 -22.5014 1.92016 -1.24665 -515 2 17.7387 7.65639 15.0691 10.2085 -5.07189 3.59706 -516 2 17.3996 6.21947 15.6455 8.09739 1.82665 -3.45815 -517 1 9.08645 12.4582 8.07298 60.2845 4.68897 0.226728 -518 2 9.45122 11.8173 7.41895 -17.2892 5.38378 7.41181 -519 2 8.16079 12.445 8.11596 -46.4448 -7.25102 -10.4423 -520 1 1.26434 1.84534 2.97351 6.14985 -4.32801 10.6126 -521 2 0.602074 2.03133 2.30849 -1.31532 11.5451 -8.74279 -522 2 1.61884 2.681 3.33622 -3.80121 -10.2767 -5.51985 -523 1 4.10472 15.1163 9.79145 -1.9934 -0.675971 8.59173 -524 2 4.064 15.4281 8.88095 5.53492 -3.39313 -4.80569 -525 2 4.98866 14.7298 9.93327 -5.1567 4.83883 -4.62826 -526 1 7.25259 2.18349 14.6213 0.0617677 -13.2081 -4.74626 -527 2 7.15489 1.70536 13.7831 -3.1697 0.657011 7.79217 -528 2 7.60954 3.02479 14.3607 5.63067 15.2107 -2.58221 -529 1 18.5424 14.6505 2.1789 -18.2195 12.8357 -3.23587 -530 2 0.746704 15.0923 2.14855 14.3998 1.01071 2.70778 -531 2 17.888 15.3836 2.15154 2.4051 -14.4939 -0.146303 -532 1 9.96619 2.7451 12.9133 2.94451 10.1866 18.8487 -533 2 9.87163 2.03702 12.2777 -5.79326 -7.02869 -14.8001 -534 2 9.15272 3.27293 12.9211 3.46257 -1.15836 -6.04557 -535 1 2.89008 8.93457 13.069 -0.378913 -4.03455 -0.489948 -536 2 3.23396 9.82093 12.8894 1.3587 3.50504 -2.14294 -537 2 3.63423 8.44035 13.4383 1.00579 -2.11175 -2.13579 -538 1 3.23705 8.4538 3.70316 6.66602 15.0067 -51.1451 -539 2 3.68898 9.21355 3.2191 -13.1992 -22.9024 22.1933 -540 2 3.37321 8.55056 4.62635 6.35333 11.1623 30.2444 -541 1 5.63533 7.19464 8.56829 15.13 5.19196 -11.3333 -542 2 5.75579 6.23215 8.63413 -6.09463 5.83127 4.58457 -543 2 5.06463 7.50349 9.27803 -5.30623 -7.19668 4.50769 -544 1 14.8805 1.37043 1.98087 -12.9306 20.6627 -0.801435 -545 2 14.4834 2.20569 2.28334 5.69168 -11.9007 13.5915 -546 2 15.1168 1.59638 1.09054 15.1066 -6.121 -14.4277 -547 1 8.35206 15.1867 0.801551 -2.76223 -14.7585 -5.29804 -548 2 9.12264 14.9643 1.32951 11.031 8.33032 8.58299 -549 2 7.67017 14.6008 1.15941 -5.63761 -0.337967 -3.00039 -550 1 15.5896 1.3528 7.2086 5.32958 13.3681 13.2076 -551 2 15.0272 0.817571 6.66531 -11.4451 -13.4108 -9.89715 -552 2 14.9993 2.0562 7.52457 4.21653 3.3566 -1.64766 -553 1 5.02591 13.0452 18.4884 -9.20414 -3.59717 -21.6247 -554 2 5.46138 13.1397 0.681872 7.63488 2.92653 16.7381 -555 2 5.72796 13.1696 17.8326 -7.15584 3.38504 4.08457 -556 1 15.3795 8.51367 18.1423 -0.613664 -0.0581633 13.6311 -557 2 15.7206 8.99589 17.3938 3.47957 9.7554 -12.9134 -558 2 15.3333 9.18442 0.205917 -4.60531 -6.1888 -2.54679 -559 1 12.0939 3.05244 18.336 -15.98 21.6351 4.66001 -560 2 12.5019 2.66242 0.476891 0.147771 -8.75739 -8.71627 -561 2 12.3559 2.60872 17.5248 9.46456 -12.7769 5.34739 -562 1 13.1875 12.6757 5.16147 -9.52799 6.20775 -2.46737 -563 2 13.6969 11.8811 4.95337 3.5398 -1.69434 3.58065 -564 2 13.2525 12.8475 6.11376 6.90446 -8.64397 -1.04625 -565 1 6.03627 7.1613 0.0926319 -1.4976 11.1377 0.14104 -566 2 5.76921 8.10211 0.154014 9.70457 -9.32393 -3.08293 -567 2 5.20613 6.68485 0.159604 -1.55619 -3.41243 3.21991 -568 1 17.685 15.9184 14.9825 -1.37425 0.537856 -17.3926 -569 2 16.8502 16.3506 14.966 -20.4161 12.6054 20.7942 -570 2 17.7239 15.7506 14.0369 24.1644 -10.6132 -5.26117 -571 1 13.1805 0.948047 16.6125 -8.26177 1.73564 3.5107 -572 2 14.0455 0.715926 16.9626 7.25254 0.595142 -3.17693 -573 2 12.7267 0.0993777 16.5408 2.533 -1.4889 -4.3323 -574 1 11.0204 14.5878 7.33132 -13.7805 -25.7938 -0.586216 -575 2 10.2983 13.987 7.62969 9.87943 15.8321 -1.01987 -576 2 11.8217 14.058 7.45361 -0.254224 3.6388 3.5388 -577 1 17.5119 8.53957 2.08465 9.75653 -12.9638 -10.6953 -578 2 16.6633 8.36471 2.52368 3.0717 -2.74041 -4.8374 -579 2 17.6343 7.8268 1.40004 -7.84255 17.4574 20.9547 -580 1 12.3495 7.93856 1.97915 15.2682 -24.1922 3.95646 -581 2 11.8245 8.73298 1.97607 -8.33179 10.3297 -5.28986 -582 2 12.0289 7.32679 1.29658 -2.64171 9.95394 1.06163 -583 1 11.9622 14.6462 10.3592 5.19436 44.1652 25.6085 -584 2 12.1561 13.8266 9.98193 3.67183 -41.4058 -22.2867 -585 2 11.0169 14.8072 10.2884 -7.2612 -3.28322 -4.25289 -586 1 6.85285 6.99572 15.5659 -14.0155 -24.0568 -12.8099 -587 2 7.75988 6.91015 15.2685 9.48733 7.04308 1.07731 -588 2 6.80041 7.76332 16.11 4.63477 18.9896 15.1539 -589 1 8.01222 4.65145 13.4113 -36.8067 -34.3033 -31.6859 -590 2 7.3316 4.83402 12.7007 16.1602 -3.60309 24.697 -591 2 8.38377 5.47541 13.6286 15.6027 34.5994 6.21753 -592 1 13.4241 12.174 14.3057 -4.84328 6.02619 2.2323 -593 2 13.1628 11.2453 14.2138 0.984992 -0.986947 -4.38535 -594 2 13.8661 12.446 13.4834 -0.550032 -4.72607 1.54363 -595 1 14.7341 9.44221 7.2791 -5.07947 3.15833 13.2143 -596 2 15.5444 9.94699 7.52972 -16.5583 -4.09464 -2.76463 -597 2 13.9842 9.66778 7.87655 21.0159 1.38057 -11.435 -598 1 12.706 16.9897 3.14089 12.6698 -33.6085 3.29803 -599 2 12.7844 17.2146 4.05845 5.40916 5.57996 15.4808 -600 2 12.1668 17.6603 2.78193 -20.8699 29.0634 -19.4792 -601 1 1.09001 7.14262 17.4001 -13.5934 2.13623 7.48936 -602 2 0.156991 7.24832 17.6908 14.7769 -7.58529 -2.77652 -603 2 1.13731 7.55625 16.5284 -2.3111 1.37932 -0.487878 -604 1 12.8562 5.06495 15.6988 -8.68567 -0.702669 -5.76624 -605 2 13.5471 4.4122 15.5538 8.1837 -6.12965 4.55719 -606 2 13.3218 5.91347 15.6395 -0.893164 2.09785 3.54679 -607 1 2.45402 3.36746 5.11563 -15.0026 -7.91555 0.636238 -608 2 1.84292 3.24382 5.86687 4.72922 -2.7794 -8.95345 -609 2 2.91216 4.18226 5.3072 9.55717 10.9124 5.44962 -610 1 8.31869 11.1649 13.5414 -26.3953 31.2189 -67.0184 -611 2 8.3305 10.9362 14.4299 14.6498 -23.9054 54.2316 -612 2 8.96182 10.7076 12.9898 15.0794 -7.45176 14.931 -613 1 12.9219 1.43726 13.3082 8.40674 -27.4269 12.3988 -614 2 13.6356 1.33586 12.6838 7.08718 -5.3 -10.143 -615 2 12.6036 2.28403 13.0872 -17.61 33.9058 -2.44667 -616 1 6.45277 13.6094 2.15178 17.7292 -13.553 0.669437 -617 2 5.88225 13.9257 2.84987 -12.2826 9.62032 8.12495 -618 2 7.05696 13.0019 2.62135 -3.25561 7.9246 -7.28354 -619 1 15.9319 6.53462 12.7261 -1.3149 8.22476 -13.019 -620 2 16.4256 7.00237 12.02 -4.18033 -7.18445 13.3481 -621 2 16.3662 6.74364 13.5705 0.249391 -3.37031 -2.78146 -622 1 16.8119 0.703827 9.59317 0.0549178 13.2549 -11.7388 -623 2 16.9772 18.4048 9.65541 -4.88295 -11.6626 5.05601 -624 2 16.4803 0.847119 8.68154 -1.08178 -1.2883 7.79904 -625 1 6.11652 11.6489 8.33522 -7.45125 2.78057 4.10213 -626 2 5.22601 11.4682 8.68918 7.08294 1.77705 -0.544493 -627 2 6.44454 10.7788 8.07724 4.19277 0.895061 -4.04259 -628 1 2.82334 8.71064 0.367814 57.5944 7.33247 25.2144 -629 2 2.2601 8.16366 18.5098 -36.527 -13.587 -20.7071 -630 2 2.37171 9.41868 0.829256 -17.9324 0.137834 -3.43482 -631 1 10.1122 10.4601 6.54653 2.23323 -6.08635 8.59596 -632 2 10.5188 9.74717 7.06727 -1.60105 2.20328 -1.71973 -633 2 10.6949 10.5759 5.79445 1.91861 -2.10956 -11.6412 -634 1 6.75321 15.7504 6.59889 15.4627 0.902891 -8.22878 -635 2 7.26857 15.9454 7.3825 -2.17992 1.48032 8.28293 -636 2 7.22097 16.2558 5.90647 -13.1985 0.138133 2.05084 -637 1 6.44152 13.0383 5.65846 10.3967 8.14078 0.466175 -638 2 6.75357 13.9433 5.8413 -7.70657 -8.59676 1.70002 -639 2 6.06189 12.7174 6.48437 -0.213232 -3.44089 0.434225 -640 1 16.7867 12.5398 9.78373 -0.895423 12.3409 14.8939 -641 2 16.908 11.9251 9.05274 5.68732 0.178616 -8.50939 -642 2 17.2058 13.3939 9.58039 -4.06144 -12.2084 -5.14549 -643 1 6.11722 2.93773 2.78358 1.28645 13.216 -7.71479 -644 2 6.25944 3.86133 2.4934 3.99356 -9.45804 11.966 -645 2 5.80949 2.50246 1.9813 -4.27697 -8.38821 -0.209888 -646 1 10.8697 3.19981 3.26527 3.50346 -2.80617 2.55973 -647 2 10.3917 4.00785 3.47818 -6.11785 -2.03152 -1.59068 -648 2 10.4869 2.83625 2.45753 -2.48553 0.910808 2.03729 -ITEM: TIMESTEP -50 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.80494 6.94654 17.8995 24.4982 -1.06408 -3.00226 -2 2 7.9626 7.14317 18.2754 -25.5132 0.779993 7.28642 -3 2 8.754 6.09075 17.4755 -3.81212 -4.80634 -6.17786 -4 1 18.7076 8.28828 6.77862 -17.6183 19.7289 -45.7057 -5 2 0.378325 8.05756 5.8509 -9.14495 4.02657 32.4311 -6 2 0.533056 7.77742 7.41073 20.0311 -22.8668 16.2585 -7 1 8.47587 18.7144 6.8555 -15.9357 -0.720841 9.56566 -8 2 9.33674 0.260611 6.50709 17.8925 2.772 -5.71063 -9 2 7.894 0.699709 6.41588 1.40147 0.745568 -0.352682 -10 1 6.55032 1.74908 11.6806 -30.6389 -0.0206495 8.42613 -11 2 5.72229 2.20254 12.0188 30.9536 -14.8428 -8.23206 -12 2 6.26581 0.83583 11.4478 2.55871 18.5754 3.76962 -13 1 7.01034 5.66598 2.40366 42.8029 -38.9731 -13.6875 -14 2 6.35895 6.02285 2.96016 -30.9745 25.4116 27.1882 -15 2 6.9342 6.07183 1.55014 -9.7244 15.1829 -13.9093 -16 1 16.2046 10.2277 16.1038 24.2393 -12.7483 3.49627 -17 2 17.1446 10.5017 16.2161 -25.4373 -4.23616 -6.12234 -18 2 15.647 10.9645 16.3441 -0.0961828 13.5193 2.91036 -19 1 10.6483 14.9468 2.32679 16.6528 15.7411 4.7381 -20 2 10.6274 14.3584 3.09768 -0.623134 4.2367 -1.18236 -21 2 11.2712 15.6715 2.59359 -14.1521 -13.9994 -5.33424 -22 1 17.1661 8.23718 10.6306 -11.2967 1.73071 14.301 -23 2 16.7507 8.8212 11.3018 1.93853 -3.53361 -12.158 -24 2 17.9019 8.73965 10.2686 8.0864 2.26419 -0.719652 -25 1 14.7146 15.8737 16.457 -21.3602 13.4439 -13.9077 -26 2 13.7676 16.1527 16.3582 25.6738 -5.80999 2.03747 -27 2 14.7447 15.4629 17.3289 2.78446 -2.53877 0.107495 -28 1 12.1127 13.3961 0.516068 7.29043 -9.0569 -3.36162 -29 2 11.9491 13.4845 18.198 -4.88029 1.64951 11.237 -30 2 11.4672 13.8878 1.04861 1.29785 5.2885 -8.15688 -31 1 9.32313 5.46813 3.97213 7.80738 6.41636 -30.8752 -32 2 8.77956 5.22076 4.69796 -14.0602 -7.63701 27.6376 -33 2 8.66617 5.58024 3.26537 2.47672 -2.22308 0.129141 -34 1 1.75935 4.12111 11.6197 18.1342 -37.205 15.7411 -35 2 1.54791 5.00495 11.8916 -2.97584 25.4072 4.68628 -36 2 2.32145 3.72177 12.3424 -17.0092 10.631 -21.3466 -37 1 2.03979 6.80407 8.28533 9.98525 11.4794 16.6393 -38 2 2.53906 7.28349 8.98677 -9.97253 -7.08615 -13.1486 -39 2 1.84044 5.93856 8.67612 2.99865 2.8006 -7.53122 -40 1 5.41368 4.4431 7.98609 2.04847 -7.17668 -5.4397 -41 2 5.52021 3.53426 7.6768 1.69988 -8.04832 10.7211 -42 2 4.8597 4.83563 7.32005 -13.574 8.98698 -13.1921 -43 1 3.28639 2.94557 17.481 18.7711 -22.2673 -22.0629 -44 2 3.9564 3.24513 16.8336 -6.74837 -1.29983 9.82734 -45 2 3.01936 3.73284 17.9334 -14.3576 17.7403 14.3716 -46 1 7.43065 5.38409 6.1108 -4.02947 -12.3157 -7.88053 -47 2 8.04294 5.88377 6.62432 18.8075 23.5792 8.00277 -48 2 6.91671 4.96856 6.79731 -10.3369 -11.1081 4.55684 -49 1 9.79016 6.98523 11.9902 -10.4204 5.88316 -11.2143 -50 2 10.3735 6.44493 11.4296 -8.50476 3.87141 4.17676 -51 2 9.02941 7.28204 11.4255 18.3189 -8.29917 9.01359 -52 1 14.0741 3.64931 8.08693 10.5401 -0.215179 40.0548 -53 2 14.0167 4.44403 7.56769 -3.75439 10.9765 -10.3635 -54 2 14.3054 3.9684 9.00291 -5.13065 -9.75311 -28.2231 -55 1 4.53282 17.2396 3.96388 -3.36194 -12.9595 16.5635 -56 2 5.47422 17.3897 3.95236 14.0752 8.1678 -3.62607 -57 2 4.10275 17.6636 3.22639 -0.935466 5.38311 -16.6052 -58 1 16.4462 16.5922 10.2581 -38.5234 -1.88036 17.4962 -59 2 15.5721 16.6729 10.7424 33.2408 0.640367 -11.4138 -60 2 16.1948 16.0519 9.4989 1.36351 -0.703045 -4.07641 -61 1 1.99534 4.82647 0.326236 -5.72725 6.00108 -15.6714 -62 2 2.53752 5.17962 1.03714 5.87953 4.50688 4.90779 -63 2 1.76739 5.60304 -0.220726 -2.02535 -4.08014 4.56707 -64 1 11.5531 13.2812 16.3325 -4.55485 8.80091 5.86354 -65 2 11.0534 12.4701 16.4457 -6.69668 -7.45166 4.31247 -66 2 12.0841 13.1031 15.5561 8.82157 3.01133 -6.78989 -67 1 10.1577 11.0139 16.8858 -24.3839 23.6532 0.592397 -68 2 10.5791 10.1721 16.8528 10.3809 -28.4273 -2.47871 -69 2 9.20446 10.8554 16.7431 9.15295 -0.788439 1.53623 -70 1 11.769 17.4436 13.4724 -4.31264 31.1905 -3.85112 -71 2 12.3451 17.016 12.8258 4.51875 -1.42135 -0.782751 -72 2 11.9049 18.418 13.331 2.02313 -21.8103 4.25856 -73 1 6.43699 9.33747 12.2016 -14.3685 16.3251 29.571 -74 2 6.95929 8.94901 11.512 13.8657 -1.33735 -10.2504 -75 2 6.99936 9.91985 12.7612 -5.52999 -10.4188 -15.163 -76 1 16.2506 12.8362 2.68463 10.4823 17.07 -2.68352 -77 2 17.0784 13.3466 2.55935 -9.20242 -14.0812 1.4249 -78 2 15.565 13.5285 2.65461 0.126865 -8.38924 5.57615 -79 1 0.688432 12.6159 5.91845 40.3739 4.73102 13.6953 -80 2 0.965548 12.5027 5.00914 1.60296 -4.44104 -10.7732 -81 2 18.4099 12.7183 5.90627 -44.0147 0.977299 -7.7541 -82 1 5.23962 16.4285 18.4285 2.37714 -1.84876 8.0205 -83 2 5.78786 15.7427 18.0572 3.65919 -12.8888 -12.968 -84 2 5.57695 16.4825 0.678793 -3.22986 7.92557 6.36641 -85 1 0.598604 7.70507 4.14138 -20.7786 -13.2635 7.16681 -86 2 18.6305 8.09263 3.50172 -0.345103 1.12768 -4.13337 -87 2 1.46117 7.8354 3.77399 24.2365 9.84596 -7.22116 -88 1 3.12664 8.94501 6.49467 58.7355 2.96877 -21.5552 -89 2 3.79065 8.46432 7.02112 -12.6266 6.35685 -1.15291 -90 2 2.29097 8.86083 6.88074 -41.9399 -6.12221 23.1652 -91 1 7.26988 10.3368 16.2836 11.5372 -0.463039 -18.2668 -92 2 6.61986 10.5879 15.6307 -2.48374 3.02842 -3.04887 -93 2 6.78814 10.3049 17.1036 -3.00573 -3.18181 16.2709 -94 1 11.123 0.978368 5.0094 -10.4546 8.12706 3.20432 -95 2 11.0717 1.86722 4.62246 7.34447 -2.45893 1.30193 -96 2 10.765 0.419141 4.31729 -2.84542 -7.68945 -6.73121 -97 1 4.36745 2.7997 13.2283 -2.96005 27.1446 -27.16 -98 2 4.67681 3.13482 14.0684 -0.492375 -1.19152 9.60175 -99 2 4.17697 1.87548 13.305 -2.22526 -24.419 13.8486 -100 1 8.37947 10.1962 1.80259 -4.93469 16.4683 -10.3397 -101 2 8.22749 10.8872 2.46356 1.16914 -1.49574 -1.6966 -102 2 8.71062 9.47199 2.30942 8.47484 -21.3721 12.0127 -103 1 10.3811 1.71408 15.5377 20.686 0.359172 -10.6925 -104 2 11.354 1.66546 15.4316 -15.8773 -5.06945 10.6173 -105 2 10.0964 2.02238 14.6685 -5.35844 0.742925 -2.36882 -106 1 2.68357 12.8347 7.81396 4.59418 8.51704 7.17464 -107 2 3.18489 13.5948 7.4697 -3.72618 -6.19027 -0.541735 -108 2 1.90686 12.7457 7.24856 2.42229 -2.05385 -5.50174 -109 1 3.74169 11.6981 5.12659 20.4064 16.2552 5.07347 -110 2 3.6031 10.8525 5.51837 -2.34348 -17.0347 14.1119 -111 2 3.05756 11.7956 4.48632 -17.1397 4.43934 -14.0111 -112 1 6.78306 14.4202 16.945 8.30127 18.455 -2.7408 -113 2 7.70256 14.7228 17.0235 -7.00262 -4.27134 -0.857039 -114 2 6.4289 14.8468 16.1479 2.30915 -9.19793 -2.69046 -115 1 14.2185 14.5268 3.31588 -23.2154 9.18115 10.9982 -116 2 13.6682 15.2954 3.06852 12.5657 -5.26706 1.63848 -117 2 13.7604 14.1667 4.10581 9.83524 -2.33371 -14.8176 -118 1 8.44676 18.1227 16.0393 7.73472 16.3177 -1.68025 -119 2 9.01165 17.3799 16.1525 3.2644 -34.6246 10.2309 -120 2 9.11477 0.14931 15.8801 -4.9724 20.6673 -2.43491 -121 1 4.70679 1.64341 4.91058 -17.3364 -32.3489 41.2122 -122 2 3.86106 2.04855 5.10849 -6.14561 5.35271 -2.51022 -123 2 5.03045 2.1011 4.1778 23.045 28.1017 -39.82 -124 1 14.9769 12.6712 16.4491 28.5182 -25.5733 -37.1858 -125 2 14.5585 13.1664 17.1249 -24.0861 16.0366 17.7329 -126 2 14.4092 12.4828 15.6576 3.30334 14.0855 25.2157 -127 1 15.7195 18.4537 16.8862 -41.4911 -4.79998 -47.5194 -128 2 16.474 18.4695 17.416 41.6971 -5.3201 37.0536 -129 2 15.5173 17.5216 16.6763 -0.165283 4.31671 10.9236 -130 1 1.26675 1.20722 16.5821 1.91531 -3.73727 -7.96899 -131 2 2.06576 1.68562 16.7995 9.77153 8.32265 -0.296149 -132 2 0.695796 1.45596 17.2985 -12.9769 2.74169 12.7471 -133 1 18.1595 4.46894 15.9392 -8.68238 9.49864 15.6389 -134 2 18.21 4.01948 15.1094 2.12602 -9.4702 -15.5502 -135 2 0.321646 4.30297 16.4236 6.52219 -0.344151 0.382064 -136 1 12.2433 16.9631 16.1365 30.1535 25.9085 -42.0202 -137 2 11.4764 16.7912 16.6244 -43.4812 -17.6238 21.6018 -138 2 11.9609 17.1491 15.2014 5.35486 -10.4534 20.1012 -139 1 16.0404 2.55502 18.1172 12.6912 -10.4842 9.42679 -140 2 15.6589 3.39683 18.3503 -6.59057 14.1496 4.33812 -141 2 15.9441 2.46009 17.1755 -7.16214 2.08136 -15.1428 -142 1 6.70635 13.8458 10.192 -16.5385 -19.5662 -16.6234 -143 2 6.46743 13.4829 11.0519 3.62966 4.37567 6.36784 -144 2 6.41781 13.1513 9.56037 11.5929 10.5707 5.5488 -145 1 10.1419 18.3987 2.73425 -19.4638 -25.4286 12.0097 -146 2 10.2073 0.494584 2.15475 6.00155 18.7458 -18.7245 -147 2 9.2799 18.0069 2.48337 13.6051 6.39322 6.25061 -148 1 3.04438 17.7185 6.11283 5.61436 7.93422 -10.0091 -149 2 2.18521 17.5434 5.71014 -2.22655 1.93918 -4.29169 -150 2 3.60431 18.0006 5.35738 -6.06642 -9.44159 14.8188 -151 1 12.59 16.8727 7.99688 3.41749 0.26688 0.968442 -152 2 11.9163 16.1959 7.96054 -9.29683 -10.0995 -8.1817 -153 2 12.3648 17.371 8.78825 5.01363 9.11979 0.25951 -154 1 14.8925 15.2941 8.21002 11.8118 0.190541 -21.4145 -155 2 14.0466 15.7377 8.15471 -7.99071 7.70949 7.81769 -156 2 15.2804 15.4945 7.32486 -0.0803457 -7.85257 22.8773 -157 1 17.7158 18.2428 0.330134 42.1686 22.2301 9.80157 -158 2 18.5718 17.7519 0.320787 -20.6577 0.0591745 -9.59458 -159 2 18.0296 0.514827 0.540707 -19.3386 -19.3229 -5.27308 -160 1 0.848087 10.4587 1.36302 27.1846 51.9138 -28.6855 -161 2 0.125428 9.973 1.66463 -44.0007 -34.6793 17.9508 -162 2 0.450253 11.2027 0.827225 17.544 -22.8417 14.6566 -163 1 1.73752 12.2317 3.35921 -10.6222 -3.23772 -40.3174 -164 2 1.50468 11.5771 2.65039 3.80547 3.73659 24.0112 -165 2 1.78112 13.0447 2.82871 4.93945 -0.670418 11.0651 -166 1 0.61763 17.2312 4.89977 -31.3278 9.09129 49.7394 -167 2 18.753 18.067 4.93438 12.2337 -8.61092 -13.4292 -168 2 0.309388 16.8063 5.75223 19.8395 0.744545 -34.548 -169 1 1.12081 0.925337 9.40389 -12.5044 -10.6635 0.652446 -170 2 1.34187 0.581545 10.2981 -6.32089 4.74016 -12.6461 -171 2 0.253358 0.524348 9.17819 18.5788 9.22491 5.8567 -172 1 16.7331 2.36195 13.2995 -4.07693 -18.6231 24.2357 -173 2 16.9587 2.56306 12.4093 5.05193 8.99127 -27.3142 -174 2 16.5121 1.41005 13.3069 2.86591 9.33714 2.00751 -175 1 2.6752 15.8404 12.084 -17.9655 13.8891 -13.7444 -176 2 3.1007 15.4046 12.7977 10.8605 -10.5552 20.9848 -177 2 3.18035 15.6022 11.2985 0.61387 1.79975 -2.62876 -178 1 16.4324 15.6688 6.07894 -11.0906 -29.1832 8.11987 -179 2 17.3135 15.6699 6.4691 2.82688 3.86386 -3.5648 -180 2 16.3493 16.3586 5.42897 4.86465 16.2346 -9.8305 -181 1 5.78229 5.11191 11.8099 -13.8406 10.2937 3.29755 -182 2 5.26053 5.84491 12.2174 12.8802 -11.8636 -2.84442 -183 2 5.17337 4.36282 11.7377 2.58239 3.92087 3.15374 -184 1 15.1463 4.86734 0.794152 0.864651 12.4924 -33.9562 -185 2 14.9842 4.50309 1.65022 -3.17819 -5.74322 26.2661 -186 2 14.3662 5.39647 0.571272 5.91156 -4.56503 2.45287 -187 1 16.3343 16.3902 2.05204 -8.53913 3.9795 31.3204 -188 2 16.0972 16.7844 2.93864 3.99019 -13.2916 -26.145 -189 2 16.6713 17.1379 1.5654 4.18336 9.27065 -12.2854 -190 1 0.251768 4.84384 3.8243 -5.07672 -49.1083 -0.618349 -191 2 0.303365 5.75864 3.98841 7.12191 44.1717 7.46524 -192 2 0.849427 4.39339 4.43966 -1.76195 8.48948 -7.42491 -193 1 2.97026 15.0637 15.1648 0.961584 14.1925 -19.6325 -194 2 2.86359 14.8338 16.0871 -5.01806 -10.0022 10.5852 -195 2 2.57214 15.9549 15.1104 2.70735 -9.48442 0.706884 -196 1 1.14871 14.6442 9.53518 -42.8529 -19.211 3.24989 -197 2 2.06628 14.849 9.52706 28.3433 -3.949 4.37311 -198 2 1.01023 13.7361 9.90627 12.772 19.4662 -8.86837 -199 1 13.5229 16.5669 11.532 20.3549 -23.4698 16.7524 -200 2 13.3606 17.2446 10.8944 -12.6142 15.9017 -14.8664 -201 2 13.2357 15.729 11.1267 -5.06335 10.0173 1.96475 -202 1 4.64907 1.44855 0.782556 14.1843 16.2277 -15.4645 -203 2 4.13811 2.00007 0.175187 -1.198 1.13782 0.731863 -204 2 4.05002 0.760268 1.05534 -6.36237 -9.04178 10.9284 -205 1 1.45269 18.5669 11.8512 9.08594 -18.5638 20.5671 -206 2 1.3209 0.513151 12.6112 1.192 -1.45307 -0.682323 -207 2 1.82538 17.7349 12.2384 -6.22294 17.2853 -13.4176 -208 1 11.5083 10.14 3.99231 -12.3356 -6.67004 24.2683 -209 2 11.3008 10.4626 3.12291 -1.30093 6.41155 -12.7666 -210 2 12.4624 10.1697 4.04844 12.7044 -2.53047 3.95194 -211 1 8.22637 12.1595 3.70182 22.1984 -6.43536 -24.1249 -212 2 9.06359 12.543 3.994 2.39995 3.52197 1.898 -213 2 7.64229 12.2644 4.4292 -22.7553 4.87752 31.4773 -214 1 14.5041 4.04055 3.28708 -18.3332 1.47774 -0.327682 -215 2 14.9873 3.94029 4.11097 10.9182 2.80533 4.02706 -216 2 13.7169 4.55783 3.53097 2.05743 -3.46177 -0.871318 -217 1 5.62743 1.64825 7.52429 33.006 28.3977 -54.9531 -218 2 5.01294 1.12929 7.98513 -35.2623 -28.0367 23.7041 -219 2 5.43705 1.49837 6.5464 4.70081 6.15592 32.4881 -220 1 17.8649 1.10253 4.84999 -3.85271 -3.04411 9.89583 -221 2 18.5316 1.48406 4.28754 10.0589 0.579138 -13.4652 -222 2 17.9089 1.63153 5.65146 -2.44801 0.268727 5.2117 -223 1 6.82865 9.41118 4.50161 13.9732 -1.80028 18.7676 -224 2 6.94383 9.68391 5.43824 -8.65407 -5.40133 -16.2957 -225 2 7.70845 9.07477 4.25578 -5.27921 1.965 -0.840285 -226 1 2.66065 14.8943 1.98186 -2.57221 -9.24308 25.7982 -227 2 3.31586 14.7955 2.69868 -8.68087 -2.61777 -7.29774 -228 2 3.12007 15.367 1.30687 7.03004 7.53846 -18.6884 -229 1 17.3318 12.9277 13.2024 14.566 -8.41998 -6.98679 -230 2 16.4646 13.2932 13.3909 -3.11164 10.4066 0.365823 -231 2 17.9245 13.6681 12.9725 -15.6789 -3.68206 1.74475 -232 1 14.9332 10.5631 1.42248 26.9386 23.5346 15.1493 -233 2 15.5074 11.3103 1.7869 -22.4798 -24.8917 -12.2482 -234 2 14.0193 10.8096 1.5708 -2.19259 1.9486 -0.294463 -235 1 5.71089 6.73608 4.5629 -4.22281 28.118 -3.03355 -236 2 5.94827 7.69445 4.64343 -4.82413 -18.183 -7.3163 -237 2 6.31292 6.28304 5.16113 4.14578 -2.25186 0.1588 -238 1 7.97883 8.3192 10.3001 7.8407 -5.86676 -34.7961 -239 2 8.53275 9.01778 9.91692 4.61581 1.53144 9.76809 -240 2 7.67805 7.86001 9.48783 -4.88471 -0.599295 18.8237 -241 1 13.4226 18.4487 5.72909 4.08913 1.21656 -6.98532 -242 2 12.585 0.250804 5.52036 7.76092 4.80861 -0.84516 -243 2 13.2097 17.9386 6.50687 -2.642 -10.6174 11.5339 -244 1 0.0869602 2.62265 0.223952 -9.8031 -15.3274 -6.51765 -245 2 17.9117 2.88521 18.4333 -9.97249 -6.92357 5.22107 -246 2 0.604672 3.41479 0.198655 20.2406 16.0872 6.75582 -247 1 12.7806 11.0275 9.75202 47.836 -29.2198 23.6504 -248 2 11.892 10.9606 9.4924 -44.5823 -3.62186 -10.7645 -249 2 12.9839 10.1194 10.1272 -4.83434 23.2951 -13.1663 -250 1 0.705171 12.1501 11.0469 -11.5221 2.5881 -10.739 -251 2 18.3743 12.1368 11.1638 13.8029 4.27958 5.25964 -252 2 1.13401 12.4861 11.8379 -3.00537 2.27024 12.2218 -253 1 5.1174 7.31342 13.4172 11.1181 3.69095 0.765545 -254 2 5.61979 7.99643 12.9358 -2.94992 -2.73128 4.30069 -255 2 5.6521 7.15272 14.218 -5.77355 -1.15348 -7.33249 -256 1 1.197 6.86571 11.8595 38.3077 26.916 14.5555 -257 2 0.451078 7.27927 11.4324 -8.7071 4.85333 -5.01967 -258 2 1.83731 7.62187 12.0983 -31.0022 -32.2106 -6.42275 -259 1 15.4885 9.63727 12.3206 16.478 -29.8614 -10.1392 -260 2 15.1661 10.5006 12.1398 -12.0715 29.4427 -0.903292 -261 2 15.2587 9.41843 13.2151 -2.74274 1.51694 14.7591 -262 1 16.5678 12.6919 5.49509 2.68502 5.28083 21.2685 -263 2 16.324 13.6184 5.59953 -0.326156 6.48336 2.9395 -264 2 16.4016 12.5196 4.57887 -2.84479 -5.20052 -25.0662 -265 1 6.28213 9.87258 0.0490999 16.8985 1.83912 15.6964 -266 2 5.56262 10.3905 0.421328 -3.89363 2.12479 6.12138 -267 2 7.01982 9.90555 0.722608 -19.7924 2.8001 -17.1777 -268 1 12.2865 6.1036 4.06304 19.2748 24.5544 -29.5048 -269 2 12.3306 6.8161 3.36437 1.4085 -17.3408 22.8012 -270 2 11.3814 5.83426 4.0192 -21.2841 -11.2083 4.33393 -271 1 0.298047 12.7955 0.166375 -3.43648 3.64279 0.0778505 -272 2 -0.0290314 13.4316 0.817326 3.1389 2.62115 2.93426 -273 2 18.4391 12.9788 18.0124 -4.25126 3.67416 -7.60949 -274 1 3.647 18.6117 8.59889 -15.5834 11.8668 6.1299 -275 2 3.50703 18.267 7.70639 0.18727 -3.89186 2.0216 -276 2 2.76186 0.338497 8.83167 17.7751 -6.65964 -2.12733 -277 1 7.50606 17.376 4.49824 -10.0508 -46.4512 11.7168 -278 2 7.49016 18.3059 4.51667 7.03352 43.591 -0.815572 -279 2 7.72157 17.1186 3.60818 -1.05523 3.68228 -12.2984 -280 1 9.25162 17.1195 12.2401 -20.7119 -1.17481 -13.1138 -281 2 9.34873 16.3083 11.723 0.965197 -1.09758 -0.258815 -282 2 10.0653 17.2534 12.7074 19.1017 -2.42392 11.5163 -283 1 13.35 12.9891 7.98546 26.3101 20.7404 -8.62941 -284 2 13.4089 12.1901 8.49273 -4.66259 -15.0904 10.7497 -285 2 14.2093 13.4501 8.17144 -24.2961 -0.252284 -5.87391 -286 1 14.9018 2.99422 15.3537 -18.6075 -8.06583 14.6174 -287 2 14.2375 2.30647 15.2045 2.81445 1.4476 3.5012 -288 2 15.4631 2.94521 14.5905 14.0528 3.89371 -13.7736 -289 1 9.86333 15.5824 16.9775 -1.70109 -0.0675876 9.27141 -290 2 10.3396 14.7637 16.7526 0.856458 3.65656 -1.57854 -291 2 9.55317 15.4797 17.8978 1.12056 -0.962034 -11.839 -292 1 11.2957 8.40029 16.577 -16.0633 -20.1101 7.86553 -293 2 10.6817 7.8482 16.0424 7.68237 12.4971 4.88138 -294 2 11.3251 7.92133 17.4322 4.78934 8.39937 -13.6138 -295 1 3.89281 18.1695 16.7848 -3.14598 -18.8551 -14.8366 -296 2 4.41813 17.5168 17.2844 -2.97968 13.5676 2.86087 -297 2 3.87713 0.360621 17.2331 6.32956 9.89438 13.0847 -298 1 2.18947 4.17934 8.91366 -18.0693 4.35017 -17.8699 -299 2 3.09766 4.08917 8.6846 23.1764 -2.78898 -7.58361 -300 2 2.16493 4.06394 9.84833 -5.05649 -4.17918 28.8808 -301 1 9.87375 10.372 9.69798 10.3489 -25.1121 17.1783 -302 2 9.47622 11.1704 9.40878 -10.9495 28.2307 -13.2887 -303 2 10.0218 10.4724 10.6474 2.61027 -3.39635 1.23761 -304 1 9.66501 0.904023 10.8717 -13.0386 -22.5074 -9.87351 -305 2 9.3051 0.0213231 11.0865 8.01248 8.88818 8.11202 -306 2 9.06191 1.19139 10.169 9.00305 9.82525 0.172013 -307 1 9.18563 15.0903 10.2115 17.1556 13.6164 1.72702 -308 2 8.73275 15.8289 9.78742 -0.477718 6.62954 -2.89772 -309 2 8.53792 14.3995 10.1946 -15.8858 -12.7719 2.13472 -310 1 0.946133 9.58267 10.2797 -17.999 7.07835 7.04569 -311 2 0.977457 10.4775 10.6382 -6.96742 -0.068666 -4.76802 -312 2 1.85682 9.38261 10.1843 21.4216 -13.3352 -8.00245 -313 1 16.9414 4.83421 8.13223 15.4014 12.0295 -27.8426 -314 2 16.4342 5.57084 8.44793 -11.0978 12.5109 2.31217 -315 2 16.8158 4.17203 8.77314 -2.49922 -25.6846 24.7871 -316 1 14.7535 14.7061 0.203986 15.073 4.98951 -2.11802 -317 2 15.1043 15.2916 0.890887 3.3452 -1.27018 2.88153 -318 2 13.9621 14.3164 0.552408 -18.4772 -7.94901 9.40987 -319 1 3.67958 11.0243 9.53991 2.98139 -0.929731 17.0732 -320 2 3.55398 11.294 10.4695 5.20942 3.18167 -4.3207 -321 2 3.23108 11.6955 9.00414 -3.72853 0.365488 -5.84942 -322 1 11.2021 10.759 1.44219 -17.3262 -13.0718 -7.65614 -323 2 11.58 11.5828 1.16251 10.55 19.7497 -9.01804 -324 2 10.309 10.7579 1.05212 6.07305 -2.69648 6.21388 -325 1 13.1662 7.17502 12.7531 25.9391 -3.29657 1.887 -326 2 14.1362 6.96154 12.7671 -19.0435 5.16748 0.470499 -327 2 12.7272 6.32599 12.8606 -4.03684 -6.30893 0.442018 -328 1 9.61497 1.86018 0.978015 -9.58691 9.0933 -29.7593 -329 2 8.82052 1.59363 0.443821 14.7013 3.9795 16.3864 -330 2 10.1598 2.41617 0.376969 -4.12787 -12.2318 8.97473 -331 1 10.6544 13.5231 4.58863 -13.6132 -6.73185 -2.44549 -332 2 11.4017 12.9559 4.77554 12.969 -5.04099 -4.5155 -333 2 10.624 14.0848 5.36102 -2.93668 8.13722 11.8558 -334 1 14.451 1.77042 10.9566 -5.06993 -21.3108 1.92478 -335 2 15.2282 1.34301 10.5576 -2.05514 6.77792 0.416034 -336 2 14.5487 2.7176 10.8324 3.84606 4.21375 0.609558 -337 1 14.5616 12.2019 11.6619 17.6804 1.81894 22.1071 -338 2 15.3038 12.427 11.1092 19.6924 5.46932 -2.69443 -339 2 13.8862 12.1117 11.0284 -35.3643 -9.54852 -21.0379 -340 1 8.20666 5.07147 9.84086 19.0973 -30.0877 -21.2342 -341 2 7.45963 5.1784 10.3955 -25.2729 10.7477 18.5337 -342 2 8.15765 4.10536 9.6198 7.47394 24.0469 -0.436218 -343 1 1.5637 16.9015 18.3956 -12.4387 -25.8837 12.5929 -344 2 2.10927 17.2609 17.7108 10.7809 10.3745 -20.1818 -345 2 1.47705 15.9462 18.1578 7.28008 19.3441 8.23831 -346 1 1.51254 17.2865 15.33 -55.1424 19.1245 13.5119 -347 2 1.44158 18.2256 15.6397 11.4216 -23.3977 -5.64032 -348 2 0.55797 16.9673 15.4072 37.0312 4.44622 -8.61518 -349 1 3.63692 5.75726 6.07961 7.7365 -18.3794 -8.43759 -350 2 3.1745 6.31944 6.69962 -9.61621 11.1355 4.40451 -351 2 4.08899 6.28836 5.40075 -0.121738 1.87808 9.22135 -352 1 12.4625 9.47055 14.2033 -9.88788 31.7301 7.89028 -353 2 12.9131 8.72585 13.8435 10.9703 -26.4307 -11.7769 -354 2 12.2412 9.2145 15.1039 -0.841012 -4.82452 5.58465 -355 1 4.05279 15.2823 6.91192 -35.0907 -10.5097 14.3913 -356 2 3.49702 16.0377 6.67476 5.8423 0.670453 -1.17602 -357 2 4.92638 15.5321 6.67665 32.7349 8.37925 -5.72993 -358 1 0.666426 8.62945 15.01 -4.81633 6.31993 2.8284 -359 2 0.390025 9.55783 15.0778 2.6081 -0.187855 1.05312 -360 2 1.36445 8.64555 14.3512 6.1817 -1.74341 -6.99991 -361 1 12.9834 8.27358 10.2916 -19.5051 6.59204 10.6567 -362 2 13.6375 7.73399 9.85191 12.7638 -5.94229 -3.5145 -363 2 12.8815 7.86968 11.1799 4.96282 8.38227 -11.7258 -364 1 15.3269 7.75333 3.56288 29.5219 38.2257 -22.8776 -365 2 14.5855 7.35684 3.13467 -21.9298 -17.371 4.59449 -366 2 15.5403 7.50003 4.45743 -10.8574 -16.6026 13.017 -367 1 17.2887 6.69393 0.021468 15.5778 -19.6292 8.74644 -368 2 16.7574 5.92192 0.248673 1.14134 -1.83764 1.32773 -369 2 16.6558 7.32534 18.3698 -22.9594 20.3863 -6.57681 -370 1 8.86981 6.94597 7.81474 24.2415 27.8548 -9.55577 -371 2 9.77577 7.36617 7.90295 -24.2622 -15.8521 -2.69303 -372 2 8.7837 6.29392 8.50186 -0.35036 -13.7271 19.3897 -373 1 12.3819 0.576227 1.23609 4.50683 -3.19553 -2.96149 -374 2 13.3476 0.534404 1.26268 -2.04299 5.45052 6.49319 -375 2 12.129 0.50298 0.316799 -1.00379 -2.5807 -2.54403 -376 1 5.62478 15.1294 14.5559 -8.95515 -20.8805 6.21096 -377 2 4.66749 15.251 14.733 11.0075 0.339747 -2.61971 -378 2 5.99586 15.9305 14.1948 2.79164 18.0184 -3.26028 -379 1 3.86891 6.41255 1.75203 -0.0773217 -5.81596 13.5476 -380 2 3.55695 7.28194 1.50076 -6.60469 12.2107 -8.14743 -381 2 4.09127 6.52195 2.68979 -0.816275 -1.80663 -6.76426 -382 1 3.9342 11.5843 12.3776 -18.6931 -4.72392 -0.912594 -383 2 4.79227 12.0122 12.4616 2.30575 0.246561 2.78418 -384 2 3.29871 12.1178 12.8946 9.72132 -5.51488 -9.32366 -385 1 5.32882 3.8676 15.8786 0.594801 -80.2026 -15.123 -386 2 6.00417 3.18473 15.5574 -21.0433 25.388 14.8589 -387 2 5.72544 4.69544 15.8213 26.1638 51.9163 -2.72297 -388 1 14.3304 10.2034 4.48175 -27.4096 24.8129 53.7077 -389 2 14.5884 9.79586 5.33863 -8.33179 4.59428 -12.4543 -390 2 14.8538 9.80174 3.84099 29.6706 -27.6476 -38.9945 -391 1 7.77951 17.4021 9.16969 8.83259 -7.31352 -4.45478 -392 2 6.90706 17.6601 9.4324 -15.0276 -0.0996042 12.8709 -393 2 7.95009 17.9588 8.40488 9.49987 1.3194 -6.72214 -394 1 4.51552 14.5162 3.99356 4.98181 -4.90212 -22.3913 -395 2 4.52626 15.4247 4.27156 -0.518589 17.7617 2.00307 -396 2 4.31207 14.0204 4.77138 -3.57212 -17.3619 18.7252 -397 1 14.1875 7.4375 15.7998 -22.901 -10.8896 -16.0938 -398 2 15.1146 7.35808 15.6286 24.9688 -1.25651 -4.60954 -399 2 14.1131 7.89225 16.6248 1.32628 8.65776 19.0596 -400 1 2.98527 18.3068 1.9119 -4.72699 -30.9822 -37.1172 -401 2 2.49826 17.7826 1.20191 12.7581 13.6458 27.4428 -402 2 2.34371 0.225349 2.32895 -15.9948 14.8465 9.72817 -403 1 8.01181 1.59883 4.56348 -29.7821 5.07108 -10.5683 -404 2 7.46781 2.03632 3.88017 -2.37558 -3.45248 10.775 -405 2 8.87859 1.65459 4.20584 24.9106 -1.40589 -4.13938 -406 1 2.43696 14.1424 17.6778 32.6678 8.55365 0.150748 -407 2 1.74447 13.6484 18.0869 -17.757 -15.5673 8.49591 -408 2 3.25626 13.7213 18.0204 -5.64692 6.54589 -2.94203 -409 1 0.856601 1.76819 13.8909 -34.0133 7.6587 12.0684 -410 2 0.79549 1.64555 14.8654 10.1884 -1.39389 -18.6264 -411 2 18.5699 1.97567 13.6249 24.5068 -3.80874 6.24474 -412 1 4.3972 0.0813689 13.9033 -13.8751 0.78744 16.7708 -413 2 5.2251 18.2898 13.7459 20.8939 -4.75733 -3.28132 -414 2 4.21678 18.5292 14.8441 -3.95615 2.50922 -10.6456 -415 1 7.163 0.723926 18.3524 28.8431 -20.8152 -22.3389 -416 2 7.29578 0.265373 17.4701 -6.89821 16.5948 25.8874 -417 2 6.28988 1.09447 18.4079 -18.4483 2.86302 0.00697782 -418 1 16.0461 18.4126 13.9592 23.9709 4.87143 24.0859 -419 2 15.127 18.3862 13.8391 -39.1169 -4.38354 -15.9017 -420 2 16.1011 18.5404 14.9193 8.5862 0.360016 -3.75437 -421 1 10.1416 4.5234 16.2814 33.6533 37.5162 -8.59515 -422 2 11.1148 4.69187 16.0483 -33.0569 -13.9639 15.4314 -423 2 9.96481 3.59397 16.253 2.9151 -23.0089 -4.34536 -424 1 15.9284 17.7644 4.42623 32.451 -11.9188 -9.4973 -425 2 16.5348 -0.134683 4.55752 -3.00893 1.73986 -2.0661 -426 2 15.0985 18.0471 4.75447 -36.3204 13.6328 11.8833 -427 1 7.01478 17.4412 13.8546 -37.2955 -8.85564 -21.6385 -428 2 7.52749 17.7553 14.5758 15.4879 9.12118 24.9138 -429 2 7.64547 17.2338 13.1683 11.7367 1.38126 -7.54157 -430 1 13.2517 6.48941 6.59541 21.6379 18.6409 -4.45059 -431 2 14.0732 7.02646 6.4901 -17.572 -15.5204 8.29538 -432 2 12.9904 6.33391 5.6816 -8.39128 -3.46546 0.217322 -433 1 7.82903 2.34082 9.30706 0.848413 1.46751 38.8479 -434 2 7.32489 2.17899 10.1397 9.78087 5.93227 -12.3925 -435 2 7.21411 2.12937 8.62642 -15.7826 -8.09866 -24.9258 -436 1 15.1931 14.7992 13.6996 5.60594 -14.9485 0.236255 -437 2 14.8724 15.0774 14.5533 -1.16755 2.2837 13.7936 -438 2 15.0044 15.5062 13.0994 -6.5851 10.7381 -11.5383 -439 1 9.39722 8.31385 3.80437 -4.07127 17.2834 -4.44624 -440 2 10.2713 8.68973 4.00761 -3.0526 -2.08627 -0.470344 -441 2 9.46128 7.36215 3.86627 5.27028 -8.92187 3.93672 -442 1 17.7859 13.5845 16.3834 -19.0466 -29.0207 18.2461 -443 2 16.8295 13.3731 16.3512 7.31415 3.8698 0.00611806 -444 2 17.8697 14.4051 15.917 1.12921 18.7325 -11.1152 -445 1 4.94376 10.5922 2.82245 -18.0715 22.8685 -14.9529 -446 2 5.66076 10.3167 3.37377 16.0421 -11.7082 13.1735 -447 2 4.72943 11.4907 3.12728 0.871258 -13.2337 -1.99455 -448 1 3.75648 8.36099 10.0882 -2.83158 17.8244 -9.78689 -449 2 3.88314 9.30809 9.8443 -3.15161 -16.2727 -0.870444 -450 2 3.74879 8.36585 11.0419 0.849549 -1.60464 13.0402 -451 1 15.9818 6.99244 6.07768 -13.3688 18.7296 1.03973 -452 2 16.7792 7.41732 6.38792 13.9106 3.61693 3.9934 -453 2 16.2026 6.08994 5.88298 6.53831 -20.9898 -2.75314 -454 1 15.1161 7.11481 9.04764 0.565665 -31.7989 38.5144 -455 2 15.8028 7.45918 9.62834 5.57768 4.61323 -0.34974 -456 2 15.1416 7.62578 8.27782 1.5606 28.4329 -39.6698 -457 1 6.26636 12.9592 12.746 15.2088 -10.2167 -2.30532 -458 2 7.09456 12.5046 12.9751 -5.12301 -5.10662 -0.512627 -459 2 6.13107 13.5604 13.4742 -6.25916 17.1748 9.55337 -460 1 12.1295 4.51914 13.098 -40.0586 -31.7334 -0.542355 -461 2 12.3128 4.55827 14.0372 7.66008 7.87672 6.17129 -462 2 11.3118 3.91999 13.0515 32.2373 26.2449 -7.62055 -463 1 11.3854 8.14886 7.92202 -18.4022 6.94815 -10.6415 -464 2 11.9487 7.53516 7.44565 12.5498 -6.92106 -4.31871 -465 2 11.7891 8.26504 8.77918 7.07043 -0.608458 13.7447 -466 1 17.1486 10.8722 7.52372 -29.3422 15.2924 19.4167 -467 2 17.741 10.1746 7.28593 21.144 -15.6164 -13.9006 -468 2 16.9754 11.4691 6.78151 4.60435 -5.53137 -7.06809 -469 1 5.26553 18.1239 10.9774 20.3802 -2.13667 -3.01104 -470 2 4.75345 17.8709 11.7323 -12.4512 -5.88679 12.7575 -471 2 4.64325 18.2391 10.2688 -13.5246 2.23536 -17.92 -472 1 7.60715 17.4884 1.7834 -2.49749 -8.82149 -34.1915 -473 2 7.92668 16.7242 1.2322 -11.5566 19.54 16.0619 -474 2 7.18999 18.106 1.13139 15.7932 -7.79309 14.6318 -475 1 1.92845 12.8983 13.5911 -4.1829 -6.61346 -8.43532 -476 2 1.49445 12.3761 14.2737 -4.42561 -3.96966 1.7572 -477 2 2.30088 13.6477 14.0465 3.83448 15.9215 12.3791 -478 1 9.57624 6.80131 14.8487 2.82943 -31.3701 -0.177857 -479 2 9.74438 5.86263 15.1368 -4.04832 25.5486 -0.431769 -480 2 9.80341 6.81631 13.907 0.113844 6.0265 -0.426062 -481 1 15.2789 4.31862 10.7553 12.937 12.8557 31.6205 -482 2 16.1415 3.96953 11.0436 -5.39931 0.983411 -21.2391 -483 2 15.1479 4.98349 11.4601 -8.5537 -3.88808 -14.9921 -484 1 11.2581 6.18474 0.159508 31.1076 25.8623 9.85053 -485 2 11.549 5.31982 18.5294 -8.46095 -20.0483 -6.31791 -486 2 10.3153 6.29854 0.132928 -17.8901 -6.88616 -7.00405 -487 1 -0.015613 11.3989 15.0155 5.52071 0.0143375 15.3818 -488 2 18.1286 11.6803 14.2478 -6.84029 3.18322 -8.47428 -489 2 -0.24984 12.0811 15.6717 7.42423 -4.02873 -7.86488 -490 1 7.04792 9.26093 7.28081 24.8295 12.5521 -3.74072 -491 2 6.59027 8.49663 7.6071 -13.7147 -18.0719 7.78469 -492 2 7.98742 9.01504 7.31689 -8.33941 1.9664 -1.88331 -493 1 18.3308 15.3469 12.3202 -6.03602 -2.26652 6.8961 -494 2 0.60478 15.4762 12.0772 12.6515 4.5696 -6.24084 -495 2 17.7927 15.7945 11.6538 0.941578 1.81095 -5.33876 -496 1 16.5149 4.38922 5.26132 -0.591505 19.7601 -54.4807 -497 2 16.8056 3.98806 6.0517 15.8153 -15.5532 32.6352 -498 2 17.2724 4.45951 4.61195 -16.46 -3.71476 24.2381 -499 1 17.705 3.15738 10.7395 -3.58994 -28.0349 -4.43916 -500 2 -0.0357658 3.31586 11.0143 13.799 7.93723 3.46651 -501 2 17.7252 2.25587 10.3433 -5.09014 14.337 3.42017 -502 1 12.282 -0.0102014 10.1171 1.80463 -26.6374 -6.99772 -503 2 11.3739 0.250254 10.2263 -16.4794 9.03176 6.86793 -504 2 12.791 0.759276 10.3145 17.2573 22.9944 3.87451 -505 1 10.3906 9.77529 12.4736 -11.6246 -18.6488 -11.2601 -506 2 11.1162 9.76462 13.0993 9.33947 3.77576 6.26492 -507 2 10.2448 8.81959 12.3007 0.540403 13.8663 1.27912 -508 1 0.620737 2.80838 7.04076 1.85552 -26.9198 -9.07562 -509 2 0.56001 3.58776 7.58035 -0.0658531 10.9425 14.6075 -510 2 1.10446 2.13014 7.5549 -9.15748 13.0523 1.42789 -511 1 0.330306 15.2957 6.90187 -7.34135 39.0889 57.248 -512 2 0.64916 14.9551 7.78023 -6.58887 6.78122 -17.5325 -513 2 0.549392 14.6745 6.26262 18.9985 -47.7984 -33.3782 -514 1 17.0475 6.9988 15.1595 3.61332 2.27156 3.35689 -515 2 17.7695 7.63103 15.0486 -1.58895 3.22527 -3.41358 -516 2 17.4554 6.32111 15.7084 -3.97121 -9.30147 -1.03946 -517 1 9.1229 12.4841 8.04245 42.4716 -17.0961 -6.2748 -518 2 9.3803 11.751 7.44403 8.89783 14.9312 6.88846 -519 2 8.20686 12.4452 7.97952 -55.5673 6.80073 1.54221 -520 1 1.25348 1.79037 2.92813 -6.45569 8.99744 5.64127 -521 2 0.618969 2.05555 2.26044 -0.811293 0.804254 -10.1384 -522 2 1.53437 2.62736 3.32834 8.32683 -8.65344 1.50874 -523 1 4.08283 15.132 9.84955 18.6585 -7.67887 -4.13383 -524 2 4.13303 15.3467 8.91064 -4.64689 1.73023 -5.13685 -525 2 4.95775 14.7288 10.0227 -10.2431 6.10486 1.39562 -526 1 7.30601 2.19422 14.6517 -6.95706 -8.0865 3.71032 -527 2 7.17746 1.61632 13.8834 -0.940722 6.01065 3.73041 -528 2 7.50104 3.06853 14.3169 9.18921 6.42869 -7.97623 -529 1 18.506 14.6308 2.17255 -30.1365 -0.614545 -1.61255 -530 2 0.727688 15.0378 2.26332 7.05 8.92743 1.17189 -531 2 17.7886 15.3173 2.20949 19.3309 -8.24877 -2.15246 -532 1 9.97566 2.72581 12.9114 -11.2099 12.673 12.9937 -533 2 9.86165 2.06107 12.2382 3.86591 -12.7401 -14.4562 -534 2 9.16654 3.26167 12.8314 9.11555 0.77907 4.27596 -535 1 2.93178 8.92582 13.081 1.70152 2.66119 1.53014 -536 2 3.14805 9.86555 12.9479 4.31652 -6.20308 -1.56758 -537 2 3.73073 8.51399 13.4597 -8.92719 0.122715 -5.32652 -538 1 3.2497 8.49808 3.73135 7.7637 26.6897 -66.399 -539 2 3.59457 9.35475 3.3251 -8.07179 -35.8245 7.88572 -540 2 3.32757 8.66083 4.63283 0.688531 4.50937 55.9505 -541 1 5.66796 7.21231 8.59238 -0.641232 -8.3741 -2.33168 -542 2 5.55885 6.25431 8.52804 10.6614 2.37054 -1.78385 -543 2 4.98671 7.4468 9.22816 0.961703 9.61661 1.51464 -544 1 14.8738 1.42122 1.93778 -12.939 -8.09002 14.9013 -545 2 14.5066 2.19936 2.41013 13.5309 -5.26917 -12.7438 -546 2 15.3961 1.64306 1.16722 2.80937 13.5796 -4.98575 -547 1 8.4154 15.1394 0.773463 -1.23857 3.93157 -9.75401 -548 2 9.15191 15.1483 1.39458 4.79594 -7.97678 6.77178 -549 2 7.72939 14.5584 1.13871 1.01453 -0.106788 3.48853 -550 1 15.5631 1.364 7.19799 20.5383 14.1474 18.9399 -551 2 14.9704 0.811359 6.72127 -20.082 -15.4085 -14.9718 -552 2 15.0111 2.04928 7.59859 -2.39038 6.78983 -5.63995 -553 1 5.04086 13.0229 18.4653 -16.526 -4.40388 -18.1368 -554 2 5.51186 13.0765 0.64315 8.46246 3.02378 17.117 -555 2 5.66208 13.3388 17.7987 -1.33855 -1.44241 4.73678 -556 1 15.3891 8.54048 18.1286 -6.10206 -9.0298 20.9903 -557 2 15.6702 9.06907 17.396 9.32842 15.5064 -17.6225 -558 2 15.3407 9.15597 0.239346 -3.25407 -2.5962 -5.00154 -559 1 12.0788 3.07289 18.3192 12.549 -10.6185 1.49283 -560 2 12.5729 2.60825 0.359083 -9.10594 9.02489 11.6275 -561 2 12.4194 2.60778 17.5512 -7.87867 2.96301 -9.52933 -562 1 13.1665 12.6793 5.14706 7.93439 -3.9476 12.1924 -563 2 13.7696 11.9755 4.86963 -4.91093 -2.83846 -5.3825 -564 2 13.2489 12.6724 6.11347 -1.2685 5.53825 -1.32442 -565 1 6.04116 7.20215 0.12064 7.04453 6.18255 -12.3628 -566 2 5.83851 8.12748 -0.154348 1.72696 -16.7644 14.2262 -567 2 5.20617 6.73813 0.252386 -0.898724 4.83199 2.26117 -568 1 17.6547 15.8889 14.9543 35.0528 -4.14946 21.8068 -569 2 16.7907 16.2722 15.0644 -14.9966 1.76464 -15.1201 -570 2 17.9353 15.7106 14.0428 -17.4402 7.26196 -6.43436 -571 1 13.1733 0.917277 16.6395 -12.3557 8.76343 2.76166 -572 2 14.0527 0.785776 16.9891 12.1183 -2.33791 -0.0845054 -573 2 12.8033 0.0287439 16.599 0.155899 -2.85039 -4.8341 -574 1 10.9713 14.5555 7.36537 -14.2255 -14.9035 9.86762 -575 2 10.1709 14.1495 7.79489 23.622 7.7433 -12.5051 -576 2 11.716 13.9517 7.54396 -5.74804 5.50666 -0.0050929 -577 1 17.5337 8.50243 2.08938 -5.40396 -31.7286 -5.54565 -578 2 16.6651 8.377 2.51924 11.1588 5.07358 -2.60802 -579 2 17.6234 7.66639 1.54889 -0.0314299 30.6214 9.39113 -580 1 12.3599 7.90174 1.98937 3.23567 -16.3128 -6.49447 -581 2 11.7961 8.65526 1.85661 -2.62113 17.411 2.96359 -582 2 12.056 7.28247 1.30894 3.22552 -0.339632 3.88847 -583 1 11.9987 14.6627 10.3756 12.942 21.9862 15.1728 -584 2 12.1481 13.8459 9.95801 9.02096 -31.6093 -18.7525 -585 2 11.0572 14.7574 10.3761 -24.4084 6.55121 -1.49817 -586 1 6.83545 6.97591 15.5496 -11.1581 -18.4558 -7.96595 -587 2 7.75433 6.91064 15.3306 20.697 -3.79434 -9.10488 -588 2 6.829 7.75126 16.0755 -7.29309 23.7102 19.2635 -589 1 8.01446 4.61093 13.3684 -42.1501 -10.3174 -21.1074 -590 2 7.18404 4.82769 12.8493 26.4504 -9.34552 12.0218 -591 2 8.34807 5.45326 13.6307 9.05324 16.4922 6.04122 -592 1 13.4266 12.1814 14.3212 -6.42777 -0.785601 -11.9683 -593 2 13.0158 11.3184 14.1828 2.17743 -6.12306 4.21948 -594 2 13.8675 12.3621 13.4761 -0.124998 4.48227 1.48561 -595 1 14.6825 9.43166 7.27492 9.85972 28.3832 27.9741 -596 2 15.5174 9.92891 7.46534 -14.0141 -13.1604 -8.13985 -597 2 14.0576 9.79435 7.94424 7.51867 -12.8522 -19.303 -598 1 12.7091 16.9592 3.18265 16.188 -54.3303 -7.24671 -599 2 12.7269 17.2341 4.07879 2.36138 14.6014 27.6129 -600 2 12.279 17.6213 2.6979 -21.2589 39.1636 -23.5451 -601 1 1.03636 7.13727 17.3765 4.75158 -4.20474 15.7377 -602 2 0.172257 7.41544 17.719 4.25282 -10.0113 -2.57097 -603 2 1.1139 7.5113 16.5007 -3.03142 8.85376 -8.54904 -604 1 12.882 5.00728 15.6915 -13.3168 2.35737 2.40623 -605 2 13.5933 4.38686 15.8029 14.6532 -13.0711 -0.480408 -606 2 13.3236 5.8608 15.7721 -0.35756 9.80313 -2.71263 -607 1 2.42233 3.36085 5.14652 -1.4819 -20.4954 -28.2661 -608 2 1.78479 3.2289 5.83557 -10.283 -5.3637 15.3955 -609 2 2.79623 4.21009 5.29825 15.429 26.5106 10.9541 -610 1 8.29403 11.1124 13.578 -10.7346 17.3121 -71.8204 -611 2 8.44225 10.8317 14.4188 2.94407 -17.9634 86.1576 -612 2 9.02074 10.6663 13.1421 6.44484 1.50589 -14.4967 -613 1 12.9406 1.47026 13.2897 0.354478 -37.8914 22.4103 -614 2 13.6523 1.40022 12.6671 11.2026 2.70228 -18.849 -615 2 12.6313 2.34545 13.2159 -11.96 35.388 -6.53093 -616 1 6.51021 13.5896 2.17003 14.8824 -7.80817 -21.2989 -617 2 5.87965 13.8406 2.83705 -10.6705 6.78718 16.3658 -618 2 7.14425 12.9838 2.58896 -6.69863 7.51381 1.45504 -619 1 15.9112 6.50963 12.6885 16.1371 8.47906 -9.98075 -620 2 16.4229 7.02402 12.0187 -10.4906 -13.771 14.0264 -621 2 16.4535 6.54884 13.5054 -11.4677 1.21509 -6.34034 -622 1 16.8027 0.705691 9.58115 1.1294 19.8318 -8.72086 -623 2 16.927 18.412 9.70296 -4.50862 -18.5326 4.35013 -624 2 16.4766 0.834017 8.66778 -1.09927 -3.21438 5.98018 -625 1 6.10776 11.6244 8.30817 -7.08025 31.3016 10.3571 -626 2 5.31117 11.3633 8.78813 -2.85933 -0.839224 -1.79107 -627 2 6.50869 10.8152 8.04097 10.2317 -24.1838 -9.43106 -628 1 2.82434 8.71866 0.367104 27.0695 8.27339 20.5452 -629 2 2.22535 8.20379 18.5266 -22.1964 -28.7808 -30.261 -630 2 2.24775 9.38106 0.731441 -2.19807 14.7641 10.188 -631 1 10.1092 10.4559 6.56308 -0.703462 -11.3062 5.02538 -632 2 10.4957 9.70218 7.03882 1.80116 3.11275 -0.176711 -633 2 10.5447 10.4553 5.70619 3.2422 0.610478 -8.25928 -634 1 6.77867 15.7679 6.62657 -1.68281 -11.8864 -9.65654 -635 2 7.19346 15.995 7.46341 4.74707 6.17504 0.549944 -636 2 7.26738 16.2069 5.90636 -4.84487 7.71134 8.89334 -637 1 6.4599 12.9833 5.69613 7.9309 12.6721 2.99822 -638 2 6.6611 13.9194 5.88765 -3.42976 -10.7335 1.27405 -639 2 6.10779 12.6203 6.51977 -0.735551 -2.83601 -1.42622 -640 1 16.7784 12.5316 9.7686 6.64513 16.9355 2.79564 -641 2 16.9553 11.9755 9.0112 -1.14761 -14.6768 -5.4217 -642 2 17.3143 13.3158 9.58219 -8.26404 -2.19889 6.01862 -643 1 6.14902 2.92407 2.76687 9.25618 8.55881 7.16487 -644 2 6.44579 3.84137 2.53376 -9.69316 -20.3131 -2.03165 -645 2 5.73381 2.47389 2.01355 1.00911 7.28801 -3.60537 -646 1 10.8507 3.14979 3.2526 -8.20022 -5.11042 -1.435 -647 2 10.2526 3.87795 3.44424 2.28516 4.24005 3.08111 -648 2 10.4324 2.67577 2.52169 3.50832 1.84172 1.62718 -ITEM: TIMESTEP -60 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.82699 6.8727 17.8888 7.11742 1.34647 0.262135 -2 2 7.99 7.13914 18.2565 -12.0864 4.19935 8.4109 -3 2 8.62901 6.07007 17.4227 -0.244169 -11.025 -10.1388 -4 1 18.7394 8.29949 6.7561 2.34576 -2.93089 -42.9257 -5 2 0.440553 7.9626 5.87052 -19.1153 18.5732 27.9896 -6 2 0.571955 7.78688 7.39134 9.59653 -12.4008 18.4821 -7 1 8.51178 18.783 6.87295 -6.05415 -5.58023 12.25 -8 2 9.39304 0.279078 6.53812 12.1519 1.3365 -4.9205 -9 2 7.9628 0.741428 6.37316 -1.87647 6.654 -3.74148 -10 1 6.53357 1.7197 11.6944 -32.7429 -8.61455 3.24653 -11 2 5.73579 2.18358 12.0739 27.4882 -10.0969 -10.5409 -12 2 6.18445 0.855878 11.3477 8.95005 26.2974 10.8481 -13 1 6.96535 5.62987 2.3961 35.6431 -32.0928 -15.0783 -14 2 6.38293 5.93218 3.05619 -24.6612 16.4463 30.6134 -15 2 6.84916 6.21974 1.66578 -5.97717 13.8881 -18.7681 -16 1 16.1974 10.2298 16.1222 0.837184 6.4903 1.28091 -17 2 17.0743 10.6189 16.0747 2.49014 -9.13099 -5.48379 -18 2 15.6463 11.0038 16.2733 -2.87215 -2.05097 1.79245 -19 1 10.6702 14.9469 2.31164 21.9083 12.0632 13.3283 -20 2 10.6818 14.2862 3.02723 -4.43621 6.7471 -1.73288 -21 2 11.263 15.6645 2.64965 -13.2726 -10.9824 -6.65814 -22 1 17.1701 8.22403 10.7142 -10.4028 1.03109 3.96163 -23 2 16.5672 8.79102 11.2349 7.05768 -1.94337 -2.70487 -24 2 17.9333 8.77716 10.499 4.44622 1.4788 -2.07857 -25 1 14.6797 15.9035 16.4693 -22.461 3.39408 -16.7947 -26 2 13.7484 16.2021 16.2951 24.3498 -9.2952 11.1 -27 2 14.6463 15.3225 17.2482 2.4047 10.3841 -3.14234 -28 1 12.1037 13.3669 0.54665 -3.27844 11.868 -6.89748 -29 2 11.8248 13.5865 18.2899 5.63772 -9.83511 -2.25753 -30 2 11.6388 14.0254 1.08354 0.310925 -7.08728 5.11983 -31 1 9.3344 5.48343 3.92748 33.8763 5.32583 -18.4372 -32 2 8.84687 5.22044 4.68611 -23.4915 -4.94858 24.7343 -33 2 8.7079 5.56619 3.20676 -14.265 -0.820383 -3.61874 -34 1 1.71101 4.06482 11.6122 14.6912 -29.1046 6.03323 -35 2 1.58258 4.96723 11.8918 -1.25551 20.6962 3.43651 -36 2 2.34968 3.65386 12.2459 -15.6865 7.58906 -11.285 -37 1 2.0576 6.82445 8.24528 12.7796 11.6573 13.2587 -38 2 2.61911 7.2356 8.94539 -14.081 -6.70064 -12.0447 -39 2 1.89349 5.9205 8.55263 1.83531 2.80349 -1.77694 -40 1 5.39864 4.45401 7.95786 1.68333 5.33174 7.59028 -41 2 5.55249 3.50745 7.87389 -3.64833 -7.88894 -5.24716 -42 2 4.83854 4.74959 7.2381 -8.525 -1.92619 -10.156 -43 1 3.30216 2.93412 17.4505 12.3495 -29.8256 -18.8762 -44 2 3.92727 3.3713 16.8479 -0.637689 -1.64749 6.41076 -45 2 2.89532 3.6118 17.959 -11.8167 26.1488 16.8317 -46 1 7.4312 5.4352 6.15055 3.3909 -0.433751 -53.1737 -47 2 7.92374 5.97877 6.73644 15.9967 14.3411 25.9486 -48 2 6.95714 4.77392 6.61797 -10.969 -14.5624 25.0012 -49 1 9.79304 6.98632 12.0044 -11.2776 3.50532 -30.3595 -50 2 10.3262 6.37648 11.4616 -6.26095 5.52929 9.55968 -51 2 9.10346 7.3395 11.3719 14.604 -9.64535 21.0978 -52 1 14.0819 3.68689 8.0984 5.37498 8.43639 24.1843 -53 2 13.9041 4.52495 7.65095 -1.63712 -2.30615 -0.914734 -54 2 14.2511 3.92795 9.04472 -1.39906 -3.736 -24.3353 -55 1 4.49163 17.2405 3.95076 10.4122 -13.5126 12.545 -56 2 5.41424 17.4498 3.85674 17.5711 4.37719 2.71306 -57 2 4.10795 17.4238 3.10711 -15.6864 12.0721 -17.6618 -58 1 16.4063 16.5742 10.3304 -30.4876 -1.09383 10.2792 -59 2 15.5552 16.587 10.8552 23.7267 -0.690427 -17.666 -60 2 16.1781 16.1401 9.48726 -2.06021 -0.342568 9.10707 -61 1 2.01216 4.81629 0.267482 -15.744 -7.33716 -25.0709 -62 2 2.32092 5.21812 1.07081 12.8803 9.20197 12.7852 -63 2 1.84588 5.54667 -0.35429 -3.07657 2.24499 6.46529 -64 1 11.4525 13.2643 16.3577 0.360612 25.402 13.2121 -65 2 11.0472 12.4174 16.5451 -7.76012 -9.6277 -2.94397 -66 2 11.9986 13.1376 15.5855 6.89063 -5.57893 -10.2697 -67 1 10.1527 10.9848 16.8633 -20.103 19.6526 2.73515 -68 2 10.5885 10.1542 16.8545 15.6291 -29.738 -2.50548 -69 2 9.22545 10.7635 16.7018 -0.592014 4.00252 0.856412 -70 1 11.7907 17.4531 13.47 6.77179 16.9038 -5.30963 -71 2 12.2429 16.8403 12.875 5.23267 3.61287 1.34276 -72 2 12.1771 18.3441 13.2664 -10.6628 -13.9509 7.62196 -73 1 6.44648 9.35189 12.2088 11.1766 16.4313 12.1054 -74 2 7.06476 9.1188 11.5034 -9.94127 -5.08631 1.40965 -75 2 6.99588 9.90362 12.7958 -7.62877 -4.94562 -4.27954 -76 1 16.2706 12.8594 2.68209 -1.75731 9.60563 4.91889 -77 2 17.1141 13.3556 2.57766 -16.4869 -7.21292 0.814827 -78 2 15.5397 13.5204 2.75856 19.4288 -8.85346 -2.79343 -79 1 0.706006 12.6575 5.91598 14.3848 1.31093 7.35726 -80 2 1.05127 12.3982 5.06653 10.4666 0.953953 -14.2919 -81 2 18.4268 12.7017 5.73438 -31.2224 -1.2993 2.30782 -82 1 5.26466 16.4058 18.4218 -16.1073 15.9927 3.08559 -83 2 5.67174 15.6665 17.9813 11.5666 -13.4602 -0.82172 -84 2 5.61268 16.4896 0.669718 7.09967 -3.66518 0.290508 -85 1 0.630514 7.71832 4.14439 -40.0144 -22.0429 16.8318 -86 2 18.6762 8.08291 3.48621 -5.56982 2.47832 -6.04635 -87 2 1.47362 7.93412 3.82987 48.6931 13.8203 -16.755 -88 1 3.15187 8.95984 6.48267 23.8542 8.38798 -14.0929 -89 2 3.71388 8.45844 7.06344 9.53544 -4.30832 6.22463 -90 2 2.31458 8.97258 6.8974 -32.9047 0.579586 11.7619 -91 1 7.26503 10.3427 16.2788 17.1997 0.0580756 -23.1821 -92 2 6.56569 10.7121 15.7432 -4.58149 2.66195 0.233626 -93 2 6.94547 10.3415 17.17 -9.40627 -4.59594 18.3856 -94 1 11.082 0.946861 5.00581 6.19269 9.74659 5.8053 -95 2 11.2852 1.82567 4.65658 -6.55006 -0.520752 -0.877191 -96 2 10.8571 0.430046 4.22808 -5.9868 -5.86677 -2.53499 -97 1 4.345 2.8292 13.2132 -1.27186 28.7368 -8.62995 -98 2 4.51529 3.21096 14.0791 1.17168 5.0352 0.572822 -99 2 4.2316 1.91147 13.3845 -6.13817 -32.6591 5.85186 -100 1 8.38376 10.2307 1.79685 4.09005 3.74222 -19.3624 -101 2 8.31491 10.9253 2.45197 -4.24337 3.92137 10.2746 -102 2 8.66929 9.45546 2.26885 2.27917 -12.8064 10.4703 -103 1 10.3305 1.70894 15.5022 6.01592 -1.55552 8.18831 -104 2 11.2875 1.57757 15.6324 -10.5356 -0.805047 -6.9053 -105 2 10.1546 1.87921 14.5629 5.4285 2.19916 1.25738 -106 1 2.65797 12.824 7.8537 2.67737 0.310449 -2.88199 -107 2 3.19441 13.4775 7.37699 -0.834696 -1.21778 5.43137 -108 2 1.94106 12.6113 7.24505 -1.36647 0.43678 -0.0339739 -109 1 3.78494 11.7026 5.05983 17.7759 13.7966 10.32 -110 2 3.63161 10.9725 5.64962 -3.29006 -9.81966 6.20688 -111 2 3.00915 11.823 4.52928 -13.3129 -0.91097 -10.8894 -112 1 6.77794 14.436 16.9596 -4.81268 9.99067 -5.99614 -113 2 7.54793 15.0018 17.1111 -0.926912 -4.93073 -4.17577 -114 2 6.38498 14.6674 16.0968 9.73202 -0.180074 3.30595 -115 1 14.2221 14.5157 3.27778 -13.9298 6.06594 9.9851 -116 2 13.8151 15.3779 3.06073 2.11094 -9.8452 8.88116 -117 2 13.8089 14.1856 4.11 4.80477 6.02161 -17.3229 -118 1 8.54544 18.1123 16.0497 -51.2002 16.193 -5.03192 -119 2 8.97127 17.2819 16.1484 30.3531 -21.0569 10.3371 -120 2 9.10378 0.243275 16.0887 21.8256 4.58901 -4.15396 -121 1 4.6724 1.65079 4.89395 -0.428695 -35.2982 26.3678 -122 2 3.9342 2.19791 5.10489 -21.2256 11.2309 2.3914 -123 2 5.17375 2.14476 4.28849 23.1392 22.1006 -30.0951 -124 1 14.9936 12.6291 16.4673 -19.77 11.4375 -24.1827 -125 2 14.4795 13.0601 17.1383 2.64859 2.32978 20.7439 -126 2 14.3496 12.6271 15.7247 18.4778 -8.83273 3.74622 -127 1 15.7172 18.4491 16.8771 -38.7365 1.31848 -37.9731 -128 2 16.4119 18.3751 17.4758 43.0193 1.36234 40.9307 -129 2 15.3332 17.5625 16.8778 1.44654 -2.1141 -5.88546 -130 1 1.31769 1.23679 16.6144 -6.54563 -5.62507 -9.64947 -131 2 2.12749 1.70533 16.7963 11.1847 9.69542 4.67012 -132 2 0.698368 1.60678 17.2434 -6.22801 1.29783 7.94738 -133 1 18.1828 4.42633 15.9571 -10.2445 4.38521 4.02875 -134 2 18.0727 3.95797 15.1342 -1.32851 -5.12675 -7.69371 -135 2 0.442412 4.30859 16.2307 9.57607 0.794437 2.0974 -136 1 12.2114 16.9885 16.1505 19.3184 14.9656 -43.0527 -137 2 11.4192 16.582 16.4369 -30.1172 -13.2398 21.5491 -138 2 12.0643 17.0779 15.1772 3.25614 1.68146 17.8786 -139 1 16.0795 2.58494 18.1555 11.3664 -10.2705 19.274 -140 2 15.8693 3.49863 18.3 -12.3112 17.2654 5.58069 -141 2 15.8977 2.41247 17.2454 -5.4363 -1.34473 -24.067 -142 1 6.67972 13.8354 10.1508 -8.25744 -4.72138 -13.3408 -143 2 6.54568 13.5231 11.0561 -0.87434 -6.75398 -1.82198 -144 2 6.44555 13.1152 9.51962 7.50297 7.52708 13.7797 -145 1 10.1393 18.4632 2.72581 -2.6903 -13.3312 7.25948 -146 2 10.3702 0.440572 2.04373 3.08075 7.1003 -10.4416 -147 2 9.34905 18.0295 2.38643 -2.95732 2.6687 3.95308 -148 1 3.05039 17.7207 6.12428 0.448774 -3.44066 -6.39261 -149 2 2.22716 17.4884 5.64326 9.1847 7.623 2.40325 -150 2 3.74061 17.8548 5.44564 -15.5509 -1.85687 4.81473 -151 1 12.5974 16.8374 7.98109 22.5462 3.91689 -18.138 -152 2 11.9813 16.1063 7.98041 -18.255 -3.99171 0.854341 -153 2 12.4106 17.4726 8.66951 -8.78709 2.06599 13.7307 -154 1 14.8906 15.2874 8.20197 12.2291 6.1037 -1.40009 -155 2 14.0169 15.6824 8.32954 6.14586 6.92547 -6.68196 -156 2 15.3058 15.6925 7.40177 -13.6896 -13.6819 15.1947 -157 1 17.774 18.2462 0.317021 16.5526 -0.292921 -8.65749 -158 2 18.517 17.6459 0.018512 -14.2865 26.6269 11.4024 -159 2 18.1212 0.514643 0.485201 -2.53379 -23.9559 -4.59837 -160 1 0.824062 10.4854 1.38532 29.0751 41.1299 -24.8426 -161 2 0.152225 9.85957 1.54468 -35.7643 -25.6114 8.77961 -162 2 0.463481 11.18 0.764874 10.1431 -20.9883 20.7352 -163 1 1.76832 12.2434 3.3342 -0.376699 -6.62105 -8.54196 -164 2 1.60728 11.5206 2.66813 -0.613387 21.7926 10.4725 -165 2 1.98383 13.0773 2.86566 -4.64348 -14.8628 -2.7215 -166 1 0.631416 17.2455 4.93339 -1.94983 -6.83399 6.66588 -167 2 18.8682 18.1422 4.98859 -2.83763 -23.6492 7.38562 -168 2 0.299607 16.5671 5.5918 8.11627 31.0276 -16.6779 -169 1 1.13057 0.905706 9.36586 -12.3827 -0.18715 22.5068 -170 2 1.31261 0.747855 10.3312 -4.25497 -2.51626 -23.3877 -171 2 0.268645 0.477115 9.21068 10.8181 5.54227 0.850191 -172 1 16.7346 2.37332 13.3038 3.72479 1.84576 21.5886 -173 2 16.9761 2.56684 12.4028 0.0757035 3.67621 -15.1405 -174 2 16.5678 1.42686 13.3713 -2.69734 -3.58003 -5.961 -175 1 2.71222 15.8556 12.0453 -23.2953 18.5694 10.7935 -176 2 3.02055 15.4773 12.8617 6.20357 -6.16654 7.20198 -177 2 3.26455 15.5565 11.3309 7.18341 -3.43964 -7.05157 -178 1 16.426 15.6488 6.1101 -14.7609 -25.4644 9.17481 -179 2 17.2826 15.6571 6.51544 16.1879 -4.44611 5.83009 -180 2 16.438 16.358 5.49538 -5.11113 23.225 -23.4349 -181 1 5.76882 5.13637 11.8122 -12.0704 17.5482 5.11471 -182 2 5.44081 5.9885 12.2003 4.95719 -19.5528 -5.70673 -183 2 5.01212 4.52871 11.8104 6.55972 2.89024 2.61392 -184 1 15.1343 4.86498 0.81249 17.6468 10.3526 -37.7608 -185 2 14.8624 4.60472 1.67155 -6.094 -8.43385 31.413 -186 2 14.42 5.38891 0.454388 -5.76674 3.16257 -0.979918 -187 1 16.354 16.4047 2.01729 -13.9507 10.6217 3.88258 -188 2 15.8491 16.8174 2.76015 19.926 -7.04016 -11.695 -189 2 16.7635 17.1307 1.5183 -3.64457 0.258913 2.52225 -190 1 0.229093 4.84171 3.85636 -16.5361 -39.1535 -9.01102 -191 2 0.280674 5.76384 3.97165 5.27146 43.6678 4.59383 -192 2 0.903367 4.46589 4.41298 10.8 -4.72049 2.86342 -193 1 2.98031 15.0696 15.1724 7.38994 17.2595 -26.1187 -194 2 2.78389 14.6733 16.0132 -4.59533 -4.91572 22.4357 -195 2 2.69496 16.0061 15.2442 -6.09825 -12.2809 0.399162 -196 1 1.14224 14.6486 9.53301 9.69931 -12.3423 3.57818 -197 2 2.08157 14.8372 9.66442 -5.69448 4.03807 -1.75917 -198 2 1.10168 13.6946 9.72739 -6.61933 10.5759 -2.74939 -199 1 13.5148 16.5367 11.5259 11.0739 -5.14125 9.92262 -200 2 13.0998 17.2443 11.0437 -3.0151 15.655 -8.61356 -201 2 13.0781 15.7617 11.1648 3.09342 -5.90037 -0.559148 -202 1 4.6468 1.4492 0.760442 21.9419 17.6404 -6.63386 -203 2 4.03376 2.00221 0.272437 -3.30289 2.18566 -6.21296 -204 2 4.11186 0.849122 1.26962 -7.6403 -10.762 3.4591 -205 1 1.46385 18.5705 11.8684 11.5971 1.37494 19.5738 -206 2 1.40443 0.572196 12.6059 -0.800227 -11.3118 -6.50307 -207 2 2.03902 17.8403 12.1929 -11.6325 11.1906 -9.16825 -208 1 11.4878 10.1514 4.00495 -23.562 -17.5625 40.225 -209 2 11.4445 10.4449 3.12053 -0.0273244 15.9845 -32.1431 -210 2 12.4087 10.0544 4.20335 22.0666 -0.101113 3.57488 -211 1 8.17978 12.1587 3.71493 28.653 -3.15285 -17.361 -212 2 9.01377 12.5671 3.97927 5.41625 0.887106 1.05136 -213 2 7.604 12.3558 4.43149 -23.5411 2.07968 29.6007 -214 1 14.5452 4.04195 3.30356 -17.0528 -5.31405 -8.64237 -215 2 15.1661 4.06926 4.02931 6.41379 4.8272 12.7333 -216 2 13.7233 4.44982 3.62226 2.87412 -0.159853 0.628569 -217 1 5.66111 1.64664 7.53337 47.3068 24.6854 -47.7691 -218 2 4.99385 1.2169 7.99076 -47.8059 -33.9417 34.4755 -219 2 5.55481 1.33937 6.59792 -2.0798 14.2024 17.8553 -220 1 17.8737 1.09537 4.84004 -13.6202 -14.1831 4.02096 -221 2 18.464 1.49436 4.20233 9.91759 7.15437 -5.32228 -222 2 17.8561 1.60546 5.65338 7.58498 6.35358 2.28946 -223 1 6.84561 9.39092 4.51119 3.77645 -4.79561 13.9854 -224 2 6.80242 9.62767 5.4641 3.30223 -6.77647 -16.668 -225 2 7.74702 9.0401 4.34673 -10.1352 5.61637 3.28246 -226 1 2.64818 14.8733 2.0031 -12.6643 -4.21043 8.13073 -227 2 3.39044 14.7832 2.61388 1.60205 1.10943 -1.58393 -228 2 2.93662 15.3311 1.21566 8.61024 -0.712779 -4.79925 -229 1 17.3356 12.9304 13.2091 0.397713 16.5012 -11.0143 -230 2 16.4513 13.2838 13.3976 5.15185 -2.46087 0.53778 -231 2 17.8465 13.7314 12.9621 -7.21788 -13.1567 2.02539 -232 1 14.9178 10.5628 1.45295 0.32879 33.5889 18.189 -233 2 15.3786 11.3985 1.79277 -12.1624 -32.8958 -12.3175 -234 2 13.9692 10.6935 1.62732 12.9477 -1.40805 -3.43718 -235 1 5.70482 6.69167 4.56094 -12.9541 28.0444 -8.31435 -236 2 5.76223 7.67071 4.46331 5.24004 -15.8993 1.97075 -237 2 6.3673 6.43877 5.21208 3.70858 -3.97365 0.601716 -238 1 7.97185 8.33683 10.3069 8.6941 -15.2025 -3.68424 -239 2 8.60404 8.92215 9.84221 -9.13329 -6.11086 -5.89913 -240 2 7.51742 7.70171 9.70626 6.59476 18.8917 -0.227694 -241 1 13.4177 18.464 5.71198 21.9916 6.6123 -14.6219 -242 2 12.6947 0.421284 5.51228 -9.11836 -2.12279 2.23123 -243 2 13.1839 18.0173 6.51737 -9.90438 -14.4062 13.6987 -244 1 0.0221035 2.62655 0.261444 12.6472 -47.1951 11.8456 -245 2 17.7527 2.75577 18.6598 -10.3686 10.7513 -7.61459 -246 2 0.546882 3.40438 0.188377 7.87852 33.0005 -3.15527 -247 1 12.8067 10.9927 9.75832 44.9647 -24.4125 8.46131 -248 2 11.8751 10.9314 9.65932 -31.4773 -7.30673 -3.09024 -249 2 13.1121 10.0761 10.034 -17.0663 24.2241 -8.13324 -250 1 0.673563 12.1459 11.0385 -14.9158 10.2345 17.3916 -251 2 18.3756 12.1565 11.2954 6.68564 0.0119082 -11.299 -252 2 1.10384 12.3853 11.8646 9.18612 4.40652 0.693569 -253 1 5.14721 7.33361 13.3929 15.7357 3.63047 1.84442 -254 2 5.59488 8.13358 13.0475 0.482915 -12.4288 -2.35902 -255 2 5.71887 7.03407 14.1269 -8.93121 6.52874 -3.37327 -256 1 1.18567 6.84505 11.8697 14.6786 34.5125 12.17 -257 2 0.393465 7.21987 11.4553 4.74321 -4.21777 2.31791 -258 2 1.70022 7.64215 12.2222 -16.972 -31.3024 -13.5319 -259 1 15.4816 9.69158 12.3277 9.90347 -39.8653 -1.57959 -260 2 15.3406 10.5924 12.1653 -13.2531 41.4735 -11.5871 -261 2 15.406 9.62533 13.2698 1.46249 -6.23285 16.1579 -262 1 16.5413 12.6347 5.5059 7.75274 -6.4804 14.118 -263 2 16.3104 13.5445 5.70094 -2.97213 12.2972 0.10227 -264 2 16.3923 12.5258 4.56955 -2.98329 -0.0504447 -18.3871 -265 1 6.30461 9.82716 0.0624729 6.72618 23.4574 16.6882 -266 2 5.51437 10.3287 0.304315 -0.069722 -0.440899 2.51054 -267 2 6.96842 10.0501 0.765687 -11.6212 -9.0506 -14.676 -268 1 12.2588 6.10042 4.03099 15.0483 24.7381 -3.94445 -269 2 12.3021 6.98896 3.58767 -5.34003 -28.327 1.95056 -270 2 11.3325 5.86569 4.06669 -11.2394 -4.89225 -2.88949 -271 1 0.336489 12.822 0.136131 -4.0328 -4.68121 -1.73262 -272 2 -0.0692718 13.3776 0.815875 4.64589 5.49593 0.971726 -273 2 18.45 12.9344 17.9884 -7.92492 5.13291 -5.47118 -274 1 3.58866 18.6351 8.62238 -6.65617 9.61834 5.79691 -275 2 3.41901 18.3768 7.70859 0.297411 -7.32139 -0.213682 -276 2 2.71275 0.31261 8.92207 15.7588 -5.16119 -5.17535 -277 1 7.50496 17.418 4.49772 -12.5742 -28.6928 8.65377 -278 2 7.55283 18.3491 4.58726 6.16277 33.1384 2.27358 -279 2 7.74423 17.2559 3.59134 -1.33953 -2.22923 -11.883 -280 1 9.26392 17.1331 12.2129 -23.7136 4.99112 -6.35848 -281 2 9.34774 16.2465 11.866 0.0093118 -9.2577 -7.50778 -282 2 9.98892 17.2487 12.8038 23.7327 3.38143 15.862 -283 1 13.3751 13.0337 7.97577 10.7478 10.6887 -13.5108 -284 2 13.3787 12.2298 8.50206 6.89696 -2.46192 7.10708 -285 2 14.2592 13.4885 8.01338 -22.4634 -9.00878 7.77512 -286 1 14.8592 2.99547 15.3735 -5.27851 1.66435 23.9116 -287 2 14.1885 2.32373 15.2402 -1.63897 -5.65445 -5.41614 -288 2 15.4149 3.00295 14.6023 9.16888 -1.78425 -15.607 -289 1 9.86925 15.6154 16.9672 4.33331 -1.89849 4.26663 -290 2 10.4152 14.8537 16.7052 -6.80597 -3.90746 -0.277805 -291 2 9.57771 15.4416 17.8827 0.419377 0.378738 -9.64067 -292 1 11.2678 8.44973 16.5939 -8.08747 -14.0791 2.0813 -293 2 10.6693 7.85604 16.0792 7.94549 12.4538 10.9378 -294 2 11.4172 8.01973 17.4598 -1.80582 0.647834 -14.6449 -295 1 3.91551 18.1683 16.8005 9.39931 12.2215 14.3903 -296 2 4.49606 17.6509 17.3756 -3.52447 -10.1131 -6.81095 -297 2 3.95318 0.38369 17.2365 -5.94998 0.470214 -7.14863 -298 1 2.19966 4.20574 8.91394 -16.952 6.25086 -28.7566 -299 2 3.11163 4.1112 8.67966 19.1354 -3.54458 -0.459765 -300 2 2.10589 3.95692 9.81579 -0.00585893 -3.49833 31.5267 -301 1 9.86514 10.3731 9.72031 15.6542 -41.5135 2.74879 -302 2 9.61489 11.2182 9.40808 -14.4527 35.546 -8.7168 -303 2 10.0569 10.3888 10.6595 -0.965326 6.48855 10.4451 -304 1 9.65603 0.92083 10.8651 15.4128 -5.93628 -1.69563 -305 2 9.35399 0.0448876 11.1808 -6.92756 10.8331 -8.061 -306 2 9.08478 1.27687 10.159 0.925367 -10.2687 5.27886 -307 1 9.17601 15.08 10.2001 28.4704 15.1584 7.58672 -308 2 8.86011 15.9493 9.94215 -4.94078 5.46469 -8.90142 -309 2 8.40516 14.5378 10.1682 -22.1716 -15.7686 -1.61012 -310 1 0.908908 9.65777 10.2661 1.02783 -39.6886 -13.0526 -311 2 0.968686 10.5462 10.5861 7.37828 17.5094 1.10535 -312 2 1.79128 9.34954 9.98968 -11.6106 9.29057 7.26807 -313 1 16.9796 4.82858 8.10785 29.2892 -10.1291 -25.9715 -314 2 16.4029 5.49318 8.42182 -23.755 22.5857 11.698 -315 2 16.8784 4.07707 8.6652 -3.89501 -13.8815 13.5617 -316 1 14.7893 14.6979 0.173135 5.39554 -7.96858 -12.7144 -317 2 15.0505 15.3823 0.785417 9.36392 5.93735 12.263 -318 2 13.9789 14.3219 0.494521 -15.109 -8.03615 11.244 -319 1 3.74323 11.0124 9.54886 4.38849 -4.14114 10.1409 -320 2 3.63158 11.395 10.4392 1.27308 -1.67175 -3.21468 -321 2 3.24423 11.5652 8.93525 -2.74645 9.31742 -2.2917 -322 1 11.2573 10.7534 1.46897 -2.74628 -20.4518 -2.00657 -323 2 11.6064 11.5358 1.05536 3.45865 20.4344 -8.16659 -324 2 10.3358 10.6724 1.18755 -1.77969 3.26872 -0.743535 -325 1 13.1779 7.19199 12.7182 14.2184 -9.05364 3.75753 -326 2 14.115 6.87295 12.7816 -17.4164 8.42328 -3.38551 -327 2 12.6212 6.40428 12.8017 3.66516 -2.90974 1.8722 -328 1 9.6094 1.86333 0.961036 -1.66559 10.1622 -20.0065 -329 2 8.74982 1.7634 0.476399 21.9169 -1.84649 8.18396 -330 2 10.2659 2.29351 0.366445 -15.6421 -6.48907 5.12748 -331 1 10.6591 13.4925 4.58018 -19.1141 -0.630091 -16.1529 -332 2 11.5305 13.1262 4.70232 12.5696 -8.82773 5.21944 -333 2 10.586 14.1761 5.24203 -0.728557 4.94256 14.6221 -334 1 14.495 1.73909 10.9749 -8.14936 -7.82556 -5.33359 -335 2 15.2253 1.30703 10.5146 2.44721 2.03735 2.44955 -336 2 14.6402 2.68373 10.8341 0.821335 1.15578 7.11863 -337 1 14.5247 12.1307 11.6327 6.29346 4.76638 51.459 -338 2 15.3146 12.4097 11.1999 18.4985 9.73575 -23.8815 -339 2 13.8662 11.9319 10.9987 -20.1843 -8.01501 -29.1382 -340 1 8.1934 5.08514 9.85848 20.6286 -7.50881 -18.2265 -341 2 7.39102 5.12991 10.3666 -14.5844 -3.05188 8.40055 -342 2 8.26178 4.1705 9.49849 -5.86813 14.6103 10.9415 -343 1 1.56363 16.9354 18.4208 -1.17306 -23.9048 5.52961 -344 2 2.13897 17.2639 17.7268 3.56106 5.06395 -9.30964 -345 2 1.54669 15.9596 18.2963 3.84009 16.9778 0.440392 -346 1 1.49268 17.3196 15.3241 -27.5122 8.95969 8.58328 -347 2 1.46041 18.2525 15.6844 -4.86102 -31.3543 -7.55486 -348 2 0.570896 16.9106 15.346 29.8648 20.9529 0.539048 -349 1 3.59911 5.78915 6.06648 9.03859 -15.9659 -5.84137 -350 2 3.1214 6.40715 6.60976 -11.746 7.94276 10.4286 -351 2 4.15987 6.31414 5.47841 1.03618 -2.86439 -0.897012 -352 1 12.5136 9.4824 14.2234 -14.5482 39.9006 11.9441 -353 2 12.9252 8.74241 13.842 20.5687 -36.5434 -22.703 -354 2 12.2915 9.17254 15.1019 -4.72781 -1.84288 9.93497 -355 1 4.05984 15.2792 6.9471 -25.1121 -18.1042 13.4141 -356 2 3.54373 16.0393 6.6659 -0.213909 7.77754 -0.115815 -357 2 4.94872 15.4739 6.70425 29.3053 8.29501 -4.075 -358 1 0.70733 8.67925 15.049 -6.53077 -6.52645 2.33041 -359 2 0.403057 9.59211 15.0995 2.0449 7.24241 -1.44461 -360 2 1.39578 8.67212 14.3782 6.73055 2.7204 -4.7895 -361 1 12.9505 8.27543 10.2426 2.52256 -9.36522 19.2887 -362 2 13.7222 7.81068 9.89429 1.56507 0.683648 -5.24915 -363 2 12.8789 7.88642 11.1491 -0.00217653 14.5673 -16.6218 -364 1 15.3477 7.80216 3.55401 -12.532 5.83489 -12.7989 -365 2 14.4906 7.48222 3.33103 -16.8871 -2.65253 -29.4538 -366 2 15.2947 7.61797 4.46883 25.5814 -3.41235 36.6493 -367 1 17.266 6.70187 0.000674068 12.1195 -8.95496 8.26487 -368 2 16.7457 6.00049 0.395257 -2.87342 -9.15243 0.336143 -369 2 16.622 7.35704 18.4101 -17.4752 15.3525 -8.08793 -370 1 8.88335 6.95399 7.81342 26.8473 24.5973 -5.8387 -371 2 9.80542 7.33522 7.87938 -25.1058 -10.3372 -2.45861 -372 2 8.7714 6.40725 8.58367 -2.11125 -14.3958 16.4377 -373 1 12.3879 0.548843 1.24082 4.42765 -0.472301 -1.45686 -374 2 13.3265 0.730859 1.40339 -2.38609 2.78881 -0.689397 -375 2 12.2563 0.636326 0.292606 2.56041 -5.4085 -0.678049 -376 1 5.63248 15.1125 14.5468 -9.48886 -16.8407 5.02155 -377 2 4.69503 15.2624 14.7723 5.83199 -5.28539 -1.87026 -378 2 5.99589 15.9615 14.314 8.44734 16.7096 -6.42729 -379 1 3.85575 6.39433 1.75493 1.50274 -8.79363 8.51258 -380 2 3.48975 7.20754 1.41538 -8.87879 17.021 -2.96274 -381 2 4.03803 6.55873 2.69128 -1.36395 1.28851 -4.88856 -382 1 3.93631 11.5299 12.3893 -8.10483 -0.317118 -5.66906 -383 2 4.80663 11.9435 12.4577 -3.51298 -1.2689 0.972005 -384 2 3.32279 12.1457 12.8171 1.30391 -5.08042 -1.13556 -385 1 5.30379 3.85961 15.861 3.26535 -66.7729 -21.4105 -386 2 5.99128 3.21668 15.5051 -18.0074 17.9789 14.3955 -387 2 5.71814 4.68422 15.8683 22.7973 48.3912 1.26107 -388 1 14.279 10.1761 4.52146 -28.2637 29.6843 37.5781 -389 2 14.4726 9.82647 5.40905 -2.50301 -0.0307068 -4.88302 -390 2 14.7482 9.65242 3.92054 26.3189 -27.9191 -30.9088 -391 1 7.73542 17.3919 9.15036 20.9187 -26.1564 3.32362 -392 2 6.89787 17.6412 9.51878 -14.391 11.6651 3.78997 -393 2 7.98556 17.9488 8.40931 -4.18052 11.5531 -5.69175 -394 1 4.50439 14.5239 3.99264 11.0977 -23.3764 -48.4991 -395 2 4.56306 15.4325 4.20277 -1.38797 35.5351 15.6514 -396 2 4.31322 14.0314 4.76491 -6.35847 -16.1784 30.998 -397 1 14.1606 7.45193 15.811 -24.1382 -9.56247 -10.586 -398 2 15.0553 7.36431 15.524 24.9604 -3.00047 -8.7167 -399 2 14.2305 7.91189 16.6334 1.28104 8.01927 19.5585 -400 1 2.99693 18.3516 1.90386 -17.8633 -43.3253 -26.4279 -401 2 2.47403 17.7132 1.31624 19.6124 26.5697 18.0429 -402 2 2.33007 0.205152 2.36966 -11.145 11.7012 10.1025 -403 1 8.00896 1.59538 4.54643 -14.6935 -3.1209 6.18761 -404 2 7.42733 1.99671 3.8763 8.34922 -0.442348 -1.34208 -405 2 8.90764 1.54031 4.21745 2.64121 3.0498 -7.75206 -406 1 2.41984 14.15 17.6911 38.7391 17.8224 -8.42313 -407 2 1.65201 13.6768 17.9262 -26.9962 -21.4224 14.4939 -408 2 3.15619 13.6354 18.0755 -0.305296 5.75785 -2.4818 -409 1 0.881322 1.80893 13.8899 -12.9164 4.63859 7.1799 -410 2 0.998981 1.67187 14.8549 -5.47541 -0.367675 -15.7697 -411 2 18.568 1.96442 13.7158 18.7475 -1.65173 8.16576 -412 1 4.35626 0.108756 13.8915 -10.9503 4.16473 7.68997 -413 2 5.20313 18.36 13.6952 15.0207 -4.30703 2.98167 -414 2 4.18562 18.5651 14.8318 -0.53115 -1.77986 -5.89667 -415 1 7.21985 0.783193 18.3638 -3.94277 -6.88163 -25.1551 -416 2 7.12969 0.383485 17.4575 9.77138 9.98351 24.3944 -417 2 6.41237 1.28912 18.5059 -6.03182 -4.67978 5.08395 -418 1 15.9996 18.4041 13.9383 18.1315 -1.4443 -10.5581 -419 2 15.071 18.4425 13.7445 -14.3326 2.53282 3.85714 -420 2 16.1651 18.6473 14.8506 -8.9044 -3.87569 12.2679 -421 1 10.1939 4.54115 16.2821 35.3159 -4.68875 2.87762 -422 2 11.1919 4.40884 16.3129 -34.2522 14.5881 -3.55905 -423 2 9.86192 3.67371 16.0442 -3.43039 -7.24249 -0.81883 -424 1 15.9323 17.7355 4.44233 22.6638 -20.6434 -12.8847 -425 2 16.5412 -0.18272 4.5755 6.4476 10.7336 -1.45992 -426 2 15.0915 18.0468 4.70328 -34.4096 13.9436 14.4512 -427 1 6.99117 17.4686 13.8836 -42.0334 -7.7574 -17.1448 -428 2 7.47631 17.7428 14.6303 20.6357 14.1189 34.523 -429 2 7.65356 17.3815 13.215 15.8945 -3.28854 -19.4769 -430 1 13.2291 6.49408 6.5607 17.0277 2.09005 0.593761 -431 2 14.1816 6.76782 6.52286 -25.3304 -6.60509 -4.73803 -432 2 12.9166 6.35235 5.64754 5.89534 0.461784 7.57918 -433 1 7.85324 2.32148 9.35275 5.46391 6.9162 26.9577 -434 2 7.3686 2.17076 10.1976 2.69269 5.61176 -14.2633 -435 2 7.26481 2.08775 8.6472 -14.0957 -9.57593 -14.6111 -436 1 15.2023 14.7793 13.7187 7.74208 -16.2001 -4.59991 -437 2 14.8319 14.9596 14.5759 -4.08925 6.59301 14.3355 -438 2 15.0747 15.5488 13.1771 -7.6118 10.0658 -7.58078 -439 1 9.41047 8.32341 3.83123 -6.47708 13.1987 -5.34522 -440 2 10.2452 8.80483 3.85219 3.73168 3.01968 4.76716 -441 2 9.63137 7.40393 3.95808 -1.29777 -11.5098 0.542939 -442 1 17.7649 13.5922 16.3898 -11.4367 -25.6902 16.7919 -443 2 16.7908 13.5407 16.3666 6.32242 -2.67761 -0.626712 -444 2 17.9873 14.3645 15.8914 0.275374 22.0623 -11.5119 -445 1 4.92213 10.5724 2.8597 -4.83644 2.51404 -15.3254 -446 2 5.59736 10.2151 3.4378 8.5726 -2.027 3.49443 -447 2 4.66951 11.4171 3.23999 1.02108 -1.77966 3.70944 -448 1 3.74742 8.38157 10.0278 -2.2319 9.94706 -11.0912 -449 2 3.89489 9.30484 9.7273 -4.74563 -10.9217 8.16333 -450 2 3.84233 8.40088 10.9831 -0.997449 0.744123 6.62097 -451 1 15.9666 6.96875 6.01253 -14.8276 15.8227 3.08109 -452 2 16.7817 7.37259 6.30064 12.9112 7.94175 5.43996 -453 2 16.2196 6.12219 5.66656 5.41287 -21.5059 -0.527712 -454 1 15.1391 7.15478 9.02923 3.95319 -30.3017 38.192 -455 2 15.9165 7.52141 9.44882 9.73374 3.98045 10.059 -456 2 15.0698 7.60427 8.22918 -5.81948 28.1077 -46.3627 -457 1 6.22822 12.9188 12.7298 1.31868 -8.19268 -13.1839 -458 2 6.88351 12.2656 13.01 8.10485 3.82836 6.8834 -459 2 6.11855 13.5785 13.4162 1.19396 9.04898 12.3458 -460 1 12.1253 4.52441 13.1066 -23.5121 -14.293 -11.093 -461 2 12.4631 4.60406 14.0095 -9.44452 -2.69015 3.06865 -462 2 11.2831 3.97256 13.0795 31.8956 18.265 6.80246 -463 1 11.4055 8.12657 7.94639 -16.7563 2.96014 -17.3287 -464 2 11.9383 7.50834 7.43372 10.7385 -1.00284 -0.366803 -465 2 11.8652 8.24712 8.77366 5.83315 -1.26494 14.2429 -466 1 17.1037 10.8819 7.56719 -22.1575 4.54299 3.0458 -467 2 17.7705 10.2842 7.28531 25.0286 -24.4015 -2.83309 -468 2 16.8908 11.3655 6.76798 -3.05919 12.9941 -4.73253 -469 1 5.25302 18.1256 10.9232 26.818 -0.191878 -4.18594 -470 2 4.8269 17.8089 11.6994 -14.1597 -10.1429 18.6642 -471 2 4.64144 17.9747 10.2197 -19.8227 3.49229 -23.3423 -472 1 7.59833 17.4619 1.74995 8.37542 2.1771 -36.4257 -473 2 8.02215 16.748 1.21035 -16.0406 12.4022 13.5887 -474 2 7.374 18.1677 1.08602 7.01745 -13.9463 17.8331 -475 1 1.92633 12.907 13.6044 0.0880561 -5.46821 -16.7511 -476 2 1.47807 12.3822 14.2652 -4.39349 -7.86198 7.054 -477 2 2.32754 13.632 14.072 3.07665 17.0427 10.8635 -478 1 9.50987 6.80039 14.836 2.18935 -20.8269 12.8739 -479 2 9.79082 5.96037 15.3114 -4.54962 20.4196 -21.9392 -480 2 9.66995 6.7436 13.8735 6.47407 0.337666 8.03802 -481 1 15.2827 4.32341 10.7768 10.307 9.68599 -4.89646 -482 2 16.2397 4.0919 10.6916 -21.0983 9.39835 9.69703 -483 2 15.2266 5.10894 11.3663 5.46907 -15.4805 -5.79884 -484 1 11.3016 6.20596 0.140794 12.6043 6.09542 0.747046 -485 2 11.4786 5.29078 18.6344 12.8703 -22.3778 -2.75052 -486 2 10.381 6.25156 -0.0726873 -21.1699 14.4442 -0.985902 -487 1 -0.0715916 11.4097 14.9721 22.1692 -7.15633 35.3796 -488 2 18.1992 11.7732 14.1947 -21.0416 8.6568 -29.4322 -489 2 -0.201181 12.1402 15.5966 -0.594523 -4.50066 0.166015 -490 1 7.04588 9.27411 7.30476 9.145 16.929 -11.701 -491 2 6.64583 8.45304 7.57308 -6.76023 -15.305 10.0219 -492 2 7.98749 9.10222 7.20319 2.10913 -2.81405 2.65036 -493 1 18.3255 15.3308 12.2943 -10.9271 3.22482 1.76971 -494 2 0.551901 15.6023 12.004 16.2571 0.370549 -2.10144 -495 2 17.7334 15.6802 11.6169 -1.97195 2.58378 -3.71708 -496 1 16.5011 4.39937 5.27673 4.48444 11.2976 -56.5136 -497 2 16.7777 3.84422 5.96849 7.0389 -19.8316 37.8082 -498 2 17.2036 4.29545 4.59204 -6.79319 11.0559 14.2779 -499 1 17.7009 3.16012 10.7623 -11.0785 -13.2259 -8.21854 -500 2 -0.0365931 3.41438 10.9472 14.4195 -1.11458 2.04579 -501 2 17.6933 2.32175 10.2562 4.60522 6.17753 6.57508 -502 1 12.2846 -0.0106908 10.1146 7.09195 -37.1879 -10.2172 -503 2 11.3926 0.256016 10.2673 -25.9358 14.4274 7.98014 -504 2 12.8288 0.732071 10.298 19.2326 28.445 5.65892 -505 1 10.3866 9.75519 12.5017 -6.95633 -10.4248 -20.8372 -506 2 11.1983 9.82383 13.0055 7.4239 -2.70171 9.41801 -507 2 10.3064 8.80301 12.2683 1.05955 14.1529 10.144 -508 1 0.648708 2.774 7.07027 -1.36725 -4.55963 12.8723 -509 2 0.490272 3.61188 7.51443 -2.95105 4.17746 -2.75047 -510 2 1.10621 2.25999 7.75495 -4.79333 -3.92365 -3.87978 -511 1 0.307244 15.292 6.87913 -0.83379 49.2439 44.5727 -512 2 0.652444 15.3347 7.80405 -9.58611 -2.1659 -14.8737 -513 2 0.567348 14.4512 6.61032 15.5663 -52.8882 -22.8213 -514 1 17.056 6.99125 15.1184 -7.99596 0.858836 -4.56633 -515 2 17.7814 7.62276 14.9808 0.742784 -5.19204 3.90514 -516 2 17.4035 6.24942 15.6288 5.94943 -0.679765 0.413052 -517 1 9.13726 12.4999 8.01885 37.0353 0.885775 16.8739 -518 2 9.52568 11.8572 7.39973 -10.6447 2.68521 -0.695331 -519 2 8.21726 12.5875 7.87097 -30.0746 -3.81245 -10.8301 -520 1 1.21553 1.74407 2.88052 -2.59699 -2.39415 1.38589 -521 2 0.835324 2.14494 2.08419 1.70776 2.79001 2.24225 -522 2 1.71989 2.41102 3.3678 0.071784 1.92406 -2.09937 -523 1 4.07628 15.1457 9.88397 17.4433 -7.82557 -1.54586 -524 2 4.111 15.2412 8.92029 0.253189 0.655179 -3.36934 -525 2 4.94389 14.7737 10.148 -8.68797 4.30724 -10.2942 -526 1 7.35101 2.21809 14.6867 -7.35168 5.20952 -5.71558 -527 2 7.12719 1.57839 13.9999 0.606569 0.313122 2.88765 -528 2 7.62455 3.00796 14.1978 2.82745 -2.40467 5.3071 -529 1 18.457 14.6023 2.16488 -22.5257 23.4253 1.52633 -530 2 0.650438 15.0238 2.37846 9.31401 -4.06208 0.652559 -531 2 17.8015 15.3468 2.21006 9.59865 -20.266 -2.54542 -532 1 9.9778 2.69966 12.9163 0.655502 16.6224 11.2027 -533 2 9.96654 2.13525 12.1425 -5.01566 -7.38072 -9.38582 -534 2 9.27217 3.36428 12.8011 2.98946 -10.098 -0.342741 -535 1 2.95791 8.92102 13.0894 10.3197 8.62466 2.37945 -536 2 3.25022 9.8484 12.9226 -2.55555 -16.3803 0.657875 -537 2 3.7553 8.44758 13.4136 -17.8894 4.38499 -5.11642 -538 1 3.26012 8.5452 3.75851 7.68136 4.64814 -61.3797 -539 2 3.65213 9.34274 3.2957 -8.84339 -23.8918 18.3111 -540 2 3.19772 8.72964 4.66662 3.169 13.2307 40.2657 -541 1 5.70723 7.22602 8.61089 15.0471 5.15238 -9.7988 -542 2 5.61347 6.27934 8.4361 -3.3163 0.301479 7.52532 -543 2 4.97449 7.5436 9.15453 0.52499 -8.4302 1.10573 -544 1 14.8706 1.4621 1.8863 1.70998 27.5213 20.9307 -545 2 14.7201 2.23316 2.46749 -8.28585 -15.753 -0.675778 -546 2 15.5631 1.82311 1.33978 3.90729 -10.8233 -20.0391 -547 1 8.4891 15.095 0.746196 -1.67248 3.44686 2.60315 -548 2 9.16152 15.1411 1.43932 5.44244 -6.16758 -2.29782 -549 2 7.78914 14.5375 1.12422 -1.25934 1.00196 -2.01266 -550 1 15.531 1.37665 7.20033 20.0832 14.6351 13.3031 -551 2 14.8916 0.843079 6.76136 -18.4007 -14.9103 -14.8508 -552 2 15.066 2.19014 7.43626 -3.82192 3.26637 1.54172 -553 1 5.03616 12.9919 18.445 -16.5564 -3.92778 -1.34985 -554 2 5.49952 13.0651 0.633359 3.65082 -0.909975 11.8673 -555 2 5.58799 13.4788 17.838 5.35286 -1.67587 -4.32886 -556 1 15.4004 8.57696 18.1096 -13.5133 -17.3986 23.7812 -557 2 15.6963 9.177 17.4428 12.1428 17.8023 -17.443 -558 2 15.2132 9.11981 0.25138 2.83515 1.87454 -5.46736 -559 1 12.0742 3.0873 18.3015 -13.0771 12.9456 1.32203 -560 2 12.4416 2.71193 0.467697 5.19488 -4.15516 -6.31478 -561 2 12.3414 2.59119 17.5164 7.34103 -8.20972 9.84797 -562 1 13.1603 12.6784 5.14975 4.6094 5.88635 0.276196 -563 2 13.6665 11.971 4.72065 -1.49243 -3.38503 8.68718 -564 2 13.2851 12.6103 6.1136 1.29016 -0.295852 -5.09341 -565 1 6.06548 7.22062 0.130395 -10.0215 14.1887 -9.78073 -566 2 5.90478 8.1622 -0.126677 10.3505 -23.4507 13.8616 -567 2 5.20282 6.91875 0.452817 7.86884 -4.47391 0.318594 -568 1 17.6551 15.8705 14.9463 -5.31761 6.83655 -25.2986 -569 2 16.721 16.066 14.8837 -6.35164 3.20497 21.4179 -570 2 17.8286 15.8261 13.9944 18.3936 -6.902 3.79502 -571 1 13.1598 0.895115 16.6829 -10.2787 13.0231 -1.21317 -572 2 14.0985 0.838925 16.8484 11.7714 -2.60716 3.82434 -573 2 12.9094 -0.0108285 16.49 -7.09766 -5.67505 2.02872 -574 1 10.9245 14.5193 7.39494 -10.4099 -10.8827 23.6465 -575 2 10.1209 14.2503 7.91799 23.546 5.98273 -19.3945 -576 2 11.6246 13.8906 7.65805 -5.45953 8.29317 -8.96944 -577 1 17.5666 8.45977 2.1077 -2.45541 -18.4017 -7.84499 -578 2 16.6916 8.4078 2.54921 14.2221 -0.924117 -8.74119 -579 2 17.6058 7.68446 1.4828 -2.53767 24.5137 15.8214 -580 1 12.3693 7.85876 1.99742 11.9287 1.39128 11.652 -581 2 11.9574 8.70597 1.81668 -2.84663 4.1279 -5.57453 -582 2 12.0661 7.22941 1.33154 -5.87406 3.00715 -1.1515 -583 1 12.0244 14.6632 10.3909 28.0505 -1.98221 6.53788 -584 2 12.2154 13.9026 9.84664 0.841551 -5.23881 -6.52272 -585 2 11.0973 14.8027 10.3697 -37.2752 0.615569 -5.61626 -586 1 6.83101 6.95959 15.54 -26.922 -25.3261 -7.84618 -587 2 7.74646 6.93869 15.3131 28.0025 5.72032 -4.23149 -588 2 6.70706 7.70294 16.1074 0.47288 18.1258 13.2198 -589 1 7.99181 4.56873 13.323 -17.7662 10.8645 -2.94772 -590 2 7.11502 4.75523 12.8947 23.3848 -2.11675 2.9311 -591 2 8.34221 5.42155 13.6369 -8.03699 -10.5621 -3.57795 -592 1 13.4097 12.1854 14.3195 -5.65215 6.28756 1.83858 -593 2 13.0403 11.2921 14.2436 5.24433 -3.00833 -1.58816 -594 2 13.8498 12.3732 13.4771 -2.55607 -2.02901 -2.35573 -595 1 14.6454 9.43305 7.28195 10.7596 15.6461 6.41649 -596 2 15.5174 9.89596 7.36949 -20.7431 -7.51972 6.68313 -597 2 14.0059 9.84843 7.89782 12.5114 -5.65293 -10.9965 -598 1 12.693 16.9181 3.21868 4.13721 -47.3842 -7.97708 -599 2 12.7878 17.338 4.04875 4.47204 15.8163 32.4195 -600 2 12.4838 17.5994 2.61833 -10.0532 31.8516 -27.8744 -601 1 1.00841 7.13021 17.3596 12.9632 -6.47488 11.204 -602 2 0.140567 7.22584 17.7618 -2.41623 -7.13214 2.78808 -603 2 0.956632 7.61621 16.5408 -0.0488819 7.87685 -11.8994 -604 1 12.917 4.94058 15.6965 -33.9833 6.00302 -1.61153 -605 2 13.6432 4.4005 15.9475 28.608 -13.7192 2.54357 -606 2 13.1955 5.85458 15.7909 9.71851 9.87704 0.635703 -607 1 2.3887 3.3689 5.15584 14.955 -15.9692 -52.0278 -608 2 1.80093 3.08916 5.81858 -25.593 -10.9876 33.4797 -609 2 2.79381 4.15677 5.46164 14.8077 31.4017 13.6729 -610 1 8.27435 11.0395 13.6153 -37.0795 23.6732 -65.6931 -611 2 8.36475 10.9269 14.5167 14.9976 -12.7369 63.1872 -612 2 9.08207 10.7919 13.1709 13.5323 -11.5041 2.55762 -613 1 12.9711 1.50053 13.2758 -7.16838 -21.0368 21.1096 -614 2 13.525 1.50324 12.5105 16.6349 2.94139 -20.1138 -615 2 12.6114 2.3778 13.3258 -6.20414 13.0805 -2.33086 -616 1 6.55993 13.5741 2.17335 4.5265 3.63418 -23.4358 -617 2 5.93511 13.8533 2.83279 -12.7543 7.85744 13.7798 -618 2 7.20659 13.0527 2.65116 1.25385 -4.10852 0.808212 -619 1 15.8831 6.47501 12.6409 22.0814 4.72601 -0.603906 -620 2 16.4738 6.98335 12.028 -14.2245 -11.2946 14.6347 -621 2 16.3705 6.43226 13.5009 -10.5632 5.96191 -15.5708 -622 1 16.8031 0.705923 9.56407 -2.28595 11.5891 -8.26827 -623 2 16.6552 18.4511 9.84906 2.3526 -17.7501 5.98934 -624 2 16.3731 0.773302 8.69375 1.62838 3.03603 0.698224 -625 1 6.10625 11.6157 8.28914 -3.08711 55.9701 7.34602 -626 2 5.36711 11.2964 8.79127 -16.3164 -7.54559 6.80515 -627 2 6.5283 10.8686 7.94164 19.8706 -42.6353 -12.8098 -628 1 2.81358 8.70539 0.376179 36.8039 -5.08598 16.3747 -629 2 2.33554 8.23944 18.3571 -22.6922 -9.90678 -17.9478 -630 2 2.28148 9.42572 0.700092 -14.5476 7.98537 3.82577 -631 1 10.114 10.4289 6.56839 -5.48816 -6.21666 7.2072 -632 2 10.5648 9.70982 7.03635 1.99723 -0.0329781 -1.13968 -633 2 10.3487 10.347 5.64237 7.8387 0.67993 -6.97128 -634 1 6.81211 15.7679 6.65103 -0.348958 5.58939 -1.23617 -635 2 7.12762 16.1335 7.48534 -0.336507 -3.46393 3.99871 -636 2 7.12562 16.4168 5.9986 -1.75978 -6.48118 -4.29666 -637 1 6.49059 12.9347 5.74014 0.722488 11.3509 6.39713 -638 2 6.52544 13.8593 6.05125 4.61742 -7.45139 -3.43251 -639 2 6.13117 12.4341 6.48422 -0.637044 1.07223 -0.836688 -640 1 16.7722 12.5296 9.75372 -10.3378 8.80589 22.9139 -641 2 16.9709 11.8837 9.07779 5.41942 -3.21474 -11.15 -642 2 17.3199 13.309 9.62307 0.866334 -2.28521 -6.10033 -643 1 6.18734 2.89369 2.76381 6.70118 21.5641 -20.0406 -644 2 6.53969 3.77128 2.46465 -8.05809 -16.0544 14.4298 -645 2 5.6766 2.59589 1.99155 1.09601 -8.68373 7.94101 -646 1 10.8178 3.09588 3.24672 1.33393 -8.05069 0.148042 -647 2 10.2056 3.80475 3.46561 0.323029 3.07521 -1.63087 -648 2 10.3998 2.55919 2.55618 -0.935454 8.00813 2.52947 -ITEM: TIMESTEP -70 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.83052 6.78564 17.8747 4.81039 14.7119 7.93216 -2 2 8.02044 7.08583 18.306 -2.95347 -6.04078 -1.17349 -3 2 8.57794 6.09723 17.2713 -4.49598 -11.7014 -7.63976 -4 1 0.124161 8.31212 6.74558 -2.09679 -1.27724 -21.4903 -5 2 0.320991 8.02726 5.80661 -3.30063 7.0305 29.7013 -6 2 0.593986 7.72695 7.35611 1.84479 -1.64007 -4.64643 -7 1 8.55341 0.214487 6.89794 4.20955 -4.60902 11.3327 -8 2 9.45965 0.255338 6.58274 3.95615 -0.229119 -0.443755 -9 2 8.09377 0.850204 6.35793 -6.3823 8.35705 -5.64785 -10 1 6.52177 1.69631 11.7106 -29.0447 -4.52087 -3.66773 -11 2 5.85029 2.25877 12.1616 13.2184 -10.2105 -7.98022 -12 2 6.00884 0.936302 11.3174 15.6542 21.0994 14.986 -13 1 6.92822 5.5902 2.37948 23.4336 -17.8876 -5.1013 -14 2 6.5261 5.8779 3.18071 -18.514 8.45901 19.042 -15 2 6.74676 6.28055 1.75003 -1.36947 6.04298 -15.8103 -16 1 16.1916 10.2374 16.1412 -24.0328 -6.0953 4.14694 -17 2 17.0138 10.497 15.7581 19.6671 8.99174 -7.62884 -18 2 15.6617 11.0456 16.2513 11.6446 -5.87426 0.419849 -19 1 10.7179 14.9528 2.30402 9.26606 5.76352 20.4147 -20 2 10.604 14.349 3.06349 2.85769 5.88214 -5.84145 -21 2 11.1755 15.7297 2.69585 -5.79349 -8.7688 -7.8832 -22 1 17.1683 8.21322 10.7989 1.82063 -1.23871 -1.95171 -23 2 16.5117 8.80699 11.1832 -0.385781 3.51193 7.00123 -24 2 17.9642 8.75858 10.6912 0.976865 0.382705 -5.65698 -25 1 14.6466 15.9322 16.4418 -21.6809 -6.01765 9.50279 -26 2 13.7097 16.2329 16.4085 18.6708 -4.64396 -3.84163 -27 2 14.6751 15.3815 17.2568 4.92661 10.5457 -14.6576 -28 1 12.1005 13.348 0.567693 14.0677 -11.0124 3.49805 -29 2 11.7977 13.4785 18.3054 -3.25303 6.53047 -2.60123 -30 2 11.7369 14.0166 1.16546 -7.92056 -0.136763 -7.41856 -31 1 9.34615 5.48792 3.88275 21.7787 0.248377 2.40385 -32 2 8.84331 5.37966 4.67443 -9.14 -4.08483 27.4632 -33 2 8.65688 5.52523 3.23949 -14.702 1.76912 -26.3373 -34 1 1.6606 4.00652 11.6035 4.04251 -10.384 -6.17332 -35 2 1.67583 4.94617 11.8049 -2.44143 11.0832 5.72027 -36 2 2.2695 3.55993 12.2146 -3.92557 1.72629 -0.38872 -37 1 2.08139 6.85853 8.20375 5.25116 9.81515 7.60897 -38 2 2.56831 7.24635 8.96213 -7.90159 -5.93168 -10.5698 -39 2 2.00199 5.91426 8.39105 -0.650687 0.0621593 5.33933 -40 1 5.36768 4.45674 7.91405 -3.32795 5.87339 3.17518 -41 2 5.46396 3.51228 8.0104 5.66802 -14.4695 -1.12836 -42 2 4.78412 4.56623 7.16078 -4.98903 9.02084 -4.56071 -43 1 3.31193 2.91026 17.4243 5.25503 -22.5991 -0.535021 -44 2 3.97925 3.43469 16.9765 8.2555 0.833912 -8.18173 -45 2 2.82292 3.51814 17.9594 -9.74498 21.4045 11.9966 -46 1 7.44628 5.47686 6.16962 4.83779 4.18627 -38.8589 -47 2 7.80337 6.02378 6.84422 19.7966 19.2933 17.1246 -48 2 7.08839 4.74785 6.63594 -15.5951 -22.4752 14.0992 -49 1 9.79841 6.99298 12.0115 -14.4173 0.175621 -19.7413 -50 2 10.2338 6.25953 11.5352 -7.27244 10.6531 4.67439 -51 2 9.07403 7.33711 11.4082 20.5779 -11.7539 16.8314 -52 1 14.0932 3.73018 8.11294 -2.35225 21.206 2.79521 -53 2 13.7164 4.53948 7.70027 6.06412 -15.1972 7.35067 -54 2 14.2932 3.96864 9.04107 -1.96145 -2.4542 -11.4015 -55 1 4.4865 17.2305 3.91995 2.87421 -17.2964 21.8602 -56 2 5.37817 17.5632 3.85852 13.1015 6.2627 -4.15101 -57 2 4.01126 17.4425 3.12603 -6.70645 13.3364 -16.7923 -58 1 16.3503 16.556 10.4027 -28.8153 -10.9362 -6.11544 -59 2 15.5262 16.5238 10.94 14.5825 4.08322 -8.19499 -60 2 16.0782 16.1167 9.56389 6.69544 5.4961 14.7824 -61 1 2.00781 4.81695 0.19428 -16.7794 -3.94444 -13.379 -62 2 2.36068 5.21925 0.976813 15.1603 4.4174 16.1734 -63 2 1.77343 5.5764 18.2905 0.379182 1.41768 -5.2961 -64 1 11.3582 13.2716 16.3898 -3.93488 16.8957 9.12151 -65 2 10.9039 12.4355 16.5285 -2.10099 -6.82713 -1.65452 -66 2 11.9323 13.1324 15.638 7.04428 -4.38588 -8.74921 -67 1 10.1365 10.938 16.8467 -2.82235 24.3376 4.32555 -68 2 10.5718 10.0987 16.7812 6.05632 -17.4389 0.305733 -69 2 9.20542 10.7786 16.7086 -10.6888 -4.42603 -1.21793 -70 1 11.8139 17.4685 13.4625 16.8497 6.47801 1.45884 -71 2 12.3399 16.8066 12.9857 -2.09189 7.12722 0.625626 -72 2 12.305 18.316 13.3535 -13.8327 -6.90215 0.736174 -73 1 6.44924 9.38958 12.2401 6.69888 0.367183 -15.9058 -74 2 7.02028 9.14259 11.4734 -10.412 6.11649 20.9521 -75 2 7.00474 9.9221 12.8226 3.16796 0.0903621 -0.913647 -76 1 16.2861 12.8631 2.69282 -5.5095 27.1919 6.93721 -77 2 17.1297 13.3403 2.5399 -11.4064 -12.6315 1.20497 -78 2 15.6248 13.5969 2.82884 15.7371 -22.5818 -6.03687 -79 1 0.705842 12.6958 5.89372 11.1118 0.602373 24.8353 -80 2 1.18521 12.4959 5.09265 -4.47491 1.87676 -19.0631 -81 2 18.418 12.5564 5.72922 -11.8137 -1.703 -8.70405 -82 1 5.28198 16.3804 18.4185 -2.246 1.3069 9.83982 -83 2 5.62966 15.5825 18.0261 2.19299 -6.30074 -9.03385 -84 2 5.78103 16.4802 0.590407 -0.738213 6.24336 1.72583 -85 1 0.669378 7.71651 4.13384 -59.2278 -40.1014 26.2385 -86 2 0.0696389 8.03317 3.4616 -5.2936 5.59306 -12.1338 -87 2 1.48105 8.07531 3.93226 66.8664 27.2164 -22.0097 -88 1 3.17848 8.98449 6.48797 -11.6429 31.0556 -28.5774 -89 2 3.69754 8.52221 7.10624 17.5545 -20.4274 28.0681 -90 2 2.28321 9.06095 6.81713 -8.12873 -6.01142 5.66961 -91 1 7.27057 10.3561 16.259 12.8547 -0.986094 -7.05958 -92 2 6.52139 10.8488 15.9387 -6.88577 4.52419 -2.25862 -93 2 7.07809 10.1849 17.1799 -5.89204 -3.21212 7.89434 -94 1 11.0493 0.926342 5.00492 7.6282 -0.312775 10.2028 -95 2 11.2745 1.78939 4.63491 -8.49938 0.0964505 -4.50291 -96 2 10.791 0.378052 4.25157 -0.730025 2.38059 -0.222793 -97 1 4.31171 2.85627 13.1955 -2.92819 26.6809 -11.7177 -98 2 4.37585 3.38692 13.9969 4.42074 -3.40265 4.05123 -99 2 4.21422 1.95476 13.4751 -3.58996 -22.8444 6.9477 -100 1 8.4068 10.257 1.78795 4.04191 -13.9705 -5.37842 -101 2 8.26785 10.8775 2.49552 -4.14797 15.7472 11.4003 -102 2 8.5529 9.42866 2.25521 3.43453 -4.46737 -1.06154 -103 1 10.2803 1.70096 15.4762 8.76071 -4.61575 -1.32446 -104 2 11.1657 1.41822 15.7142 3.10462 2.167 2.36838 -105 2 10.3075 1.82832 14.5156 -8.33356 3.27592 2.91474 -106 1 2.63173 12.8085 7.89063 4.0959 -9.21484 -0.859497 -107 2 3.2295 13.3973 7.41028 -2.49756 4.22571 1.84267 -108 2 1.98308 12.5062 7.24287 -1.99659 4.67741 -0.497136 -109 1 3.82895 11.7184 5.01628 -2.65331 8.28036 11.6201 -110 2 3.66291 11.1157 5.74556 0.426771 -3.98214 -1.1075 -111 2 3.01542 11.7805 4.50368 -0.128738 -0.0731644 -2.81963 -112 1 6.76514 14.4734 16.965 3.61018 3.02569 -11.8589 -113 2 7.44445 15.1431 17.0872 4.2046 -3.50831 2.36163 -114 2 6.5725 14.4959 16.0119 -5.95898 4.08629 6.49151 -115 1 14.2172 14.5156 3.23512 -15.7654 4.80027 20.0484 -116 2 13.9157 15.4376 3.23841 -0.320177 -6.15912 -4.56224 -117 2 13.7912 14.1249 4.0321 9.04818 0.126488 -15.8424 -118 1 8.62194 18.1001 16.0659 -23.21 2.71751 -2.03066 -119 2 9.16623 17.3958 16.3546 8.59431 -35.107 8.94544 -120 2 9.24682 0.159724 16.0687 7.59352 33.2076 -10.3682 -121 1 4.64785 1.66473 4.88429 20.0976 -32.3539 12.8345 -122 2 3.91841 2.23972 4.98678 -27.2909 21.6553 1.42112 -123 2 5.29938 2.12424 4.3745 8.75708 11.4615 -15.3566 -124 1 14.996 12.6195 16.4803 11.4842 8.30008 2.93566 -125 2 14.5677 12.8295 17.3315 -5.03395 -0.949445 -14.8823 -126 2 14.3989 12.5973 15.7101 -8.95177 1.91572 10.2236 -127 1 15.728 18.434 16.8656 -21.8007 21.3443 -35.9839 -128 2 16.2692 18.4514 17.6234 28.2096 -0.560819 33.2727 -129 2 15.2446 17.617 16.9069 0.184765 -20.6285 -2.2654 -130 1 1.36479 1.27889 16.6468 -16.7944 -10.044 -5.49533 -131 2 2.14801 1.79564 16.8219 8.14362 6.44014 2.70449 -132 2 0.693336 1.65446 17.2331 2.17778 -0.49248 0.882874 -133 1 18.205 4.38071 15.9717 -12.5383 1.08179 -4.34425 -134 2 17.9247 3.87865 15.1967 2.33887 0.121173 2.56773 -135 2 0.514445 4.3883 15.9876 8.17504 0.178033 -1.34417 -136 1 12.1632 17.0104 16.1415 17.8243 8.47052 -8.26904 -137 2 11.4339 16.4838 16.4748 -11.8796 -0.396392 0.7857 -138 2 12.1013 17.0682 15.1696 -12.6199 -2.93135 7.53111 -139 1 16.1201 2.6287 18.1864 3.80406 -3.99791 19.9987 -140 2 15.7935 3.50022 18.4009 -8.69312 10.1277 7.25942 -141 2 15.8264 2.47036 17.3057 -5.74882 -3.05042 -27.5508 -142 1 6.63908 13.8237 10.1059 1.54133 -19.2408 -0.896874 -143 2 6.60488 13.4547 10.9999 -2.4531 4.12781 1.41157 -144 2 6.6237 13.027 9.53669 -1.978 12.9815 -0.0933135 -145 1 10.1367 18.5192 2.71126 14.9692 1.08893 5.4249 -146 2 10.5375 0.290475 1.93143 -3.72697 -2.23961 5.76435 -147 2 9.31873 18.1319 2.42821 -14.2623 -5.70844 -7.57952 -148 1 3.05388 17.7183 6.14163 -17.3097 -9.85118 -22.5426 -149 2 2.24205 17.5791 5.58071 14.4512 3.50974 23.581 -150 2 3.73807 17.7208 5.46344 2.0394 5.03095 2.09251 -151 1 12.6118 16.8054 7.95495 4.58219 1.15158 -10.9791 -152 2 11.8555 16.2225 7.90842 -7.26482 -13.9478 -6.78863 -153 2 12.3849 17.4156 8.64585 -0.135632 15.5831 16.1371 -154 1 14.8975 15.2817 8.22586 -10.0433 25.2404 1.15436 -155 2 14.1016 15.8482 8.35876 13.2826 -12.9576 -5.35538 -156 2 15.2902 15.6258 7.39629 -1.79461 -13.1873 12.9757 -157 1 17.8242 18.245 0.290753 35.0262 5.69882 -22.3559 -158 2 18.562 17.7688 18.4584 -26.5201 3.44978 21.3008 -159 2 18.2553 0.461923 0.458274 -15.0979 -6.94564 5.00195 -160 1 0.811942 10.4929 1.40956 8.77271 16.3938 -17.0751 -161 2 0.0922351 9.87336 1.50209 -12.9574 -8.99075 8.33498 -162 2 0.506251 11.1761 0.770938 6.09002 -9.92994 11.4815 -163 1 1.80057 12.2567 3.3157 -0.00821892 -5.58838 -28.0373 -164 2 1.51905 11.5718 2.65287 2.57103 10.7079 19.8708 -165 2 2.13035 12.9839 2.7472 -5.7627 -4.92842 11.1942 -166 1 0.668516 17.2609 4.94683 -35.85 3.98858 25.1078 -167 2 0.0697466 18.0029 5.19004 17.5579 -5.46754 -17.9658 -168 2 0.309089 16.5456 5.51301 20.6369 3.3795 -13.3957 -169 1 1.1258 0.902495 9.33726 -12.4564 -3.06084 39.8122 -170 2 1.2842 0.722879 10.3134 -2.51149 4.27857 -26.5162 -171 2 0.280567 0.461704 9.18062 1.78742 1.97705 -4.09399 -172 1 16.751 2.38387 13.3212 3.93571 18.018 2.1702 -173 2 16.8889 2.64612 12.3995 3.13812 2.89192 3.07637 -174 2 16.5572 1.45381 13.2916 -4.67688 -18.3777 2.25645 -175 1 2.721 15.8932 12.0356 -10.4038 6.64935 25.1991 -176 2 2.99704 15.5189 12.8835 -2.56405 3.43208 -4.36032 -177 2 3.3254 15.553 11.3859 5.26998 -2.53603 -11.8474 -178 1 16.4132 15.6174 6.13158 -30.6236 -31.2218 7.18947 -179 2 17.2889 15.5331 6.46785 25.936 1.45578 4.51193 -180 2 16.388 16.3213 5.51027 2.55474 24.6255 -21.834 -181 1 5.75165 5.17156 11.8076 -10.0158 20.8309 8.83951 -182 2 5.58328 6.03799 12.2608 0.394348 -20.1746 -10.5178 -183 2 4.95414 4.6515 11.9927 8.5068 -2.87995 -2.26002 -184 1 15.1308 4.87532 0.804768 27.2949 -1.75024 -19.8676 -185 2 14.8777 4.72649 1.70618 -7.53991 -8.08598 20.9925 -186 2 14.4372 5.36761 0.397065 -18.333 11.5318 -5.57633 -187 1 16.3608 16.424 1.96087 0.545069 28.5814 -7.81874 -188 2 15.9402 16.8572 2.72963 9.40909 -7.94755 -2.88814 -189 2 16.7928 17.1706 1.4719 -7.75465 -17.4072 6.82817 -190 1 0.195497 4.8427 3.9016 -20.8114 -16.3238 -7.36148 -191 2 0.347935 5.77048 3.88737 2.90582 31.823 0.953261 -192 2 1.01225 4.48793 4.21241 18.9183 -15.2676 9.08502 -193 1 2.99687 15.0761 15.1729 -7.80035 25.004 -19.9303 -194 2 2.75027 14.6107 15.9518 -1.28992 -16.7566 29.7079 -195 2 2.55205 15.9391 15.3182 6.19364 -5.6546 -9.94962 -196 1 1.13925 14.6508 9.53021 19.9076 23.5081 3.98588 -197 2 2.07639 14.8825 9.77663 -29.323 -13.131 -7.88186 -198 2 1.04812 13.6993 9.55892 5.54263 -6.82879 4.76298 -199 1 13.5171 16.5199 11.5195 20.4201 8.76324 22.1576 -200 2 12.9867 17.257 11.2155 -0.855064 7.64635 -14.0191 -201 2 13.0442 15.7467 11.2378 -7.08331 -12.4379 -10.7884 -202 1 4.66723 1.48136 0.73322 23.0149 3.26353 10.1864 -203 2 3.99044 1.945 0.247475 -7.51763 5.99594 -9.81004 -204 2 4.21698 0.879204 1.33273 -6.6714 -6.19828 -5.18082 -205 1 1.48126 18.5865 11.8932 5.77456 11.9109 13.6761 -206 2 1.45047 0.509997 12.7065 -0.655319 -12.4833 -18.3988 -207 2 2.16842 17.9125 12.0331 -8.54366 2.69761 2.01722 -208 1 11.4638 10.1444 4.04596 -29.9846 -9.43843 22.7531 -209 2 11.586 10.5695 3.21678 -1.49335 12.1472 -28.3165 -210 2 12.3366 9.99459 4.35585 30.6386 -4.62302 8.08877 -211 1 8.15809 12.1698 3.75544 16.5318 -12.8496 -25.3624 -212 2 9.0168 12.5594 3.97136 -0.0903232 2.9732 11.2136 -213 2 7.55758 12.2779 4.48666 -4.55936 7.15494 21.2951 -214 1 14.57 4.03338 3.33424 -15.9396 -3.34089 -13.9779 -215 2 15.2475 4.30951 3.93522 14.2067 0.133456 17.245 -216 2 13.7488 4.35662 3.71839 -4.37522 2.77806 -1.52286 -217 1 5.69573 1.64484 7.55416 47.4861 32.5669 -28.9041 -218 2 5.02314 1.22164 8.01158 -49.1519 -34.4826 29.3881 -219 2 5.51675 1.48645 6.61188 -4.44278 2.0561 3.75596 -220 1 17.8757 1.08291 4.8338 -2.11434 0.172647 4.71576 -221 2 18.4455 1.46692 4.16357 3.67184 -2.89676 -9.33974 -222 2 18.0165 1.6381 5.60499 -0.396504 -0.0112538 6.48923 -223 1 6.85338 9.35555 4.52322 8.01303 -7.73923 12.5712 -224 2 6.71294 9.49068 5.48294 3.02765 -1.76203 -13.5451 -225 2 7.79052 9.06961 4.44068 -13.079 3.18293 -1.46589 -226 1 2.62197 14.8521 2.02937 -10.5221 3.39156 -23.0918 -227 2 3.43005 14.7674 2.51892 12.1264 -2.78802 16.39 -228 2 2.89555 15.1253 1.13827 -2.73698 -5.91865 10.4405 -229 1 17.3299 12.9421 13.1931 -12.7738 17.025 -7.03447 -230 2 16.4383 13.2606 13.4479 14.3464 -2.45707 -5.73497 -231 2 17.7945 13.7546 12.8897 -6.22536 -14.4165 5.27249 -232 1 14.8979 10.5619 1.48982 -11.9525 28.8063 14.5441 -233 2 15.3485 11.4081 1.81139 -13.0513 -30.8314 -8.90843 -234 2 13.9324 10.6539 1.67123 25.3412 1.8999 -4.23485 -235 1 5.67595 6.67872 4.55433 0.362155 18.5292 -10.9955 -236 2 5.7867 7.61135 4.29326 0.453279 -5.37291 7.09585 -237 2 6.40948 6.48302 5.14674 -0.086512 -6.41659 5.49044 -238 1 7.99316 8.32936 10.3099 -9.88556 -13.348 -36.673 -239 2 8.52429 8.77949 9.6279 3.30308 5.35046 16.0689 -240 2 7.32365 7.86355 9.75728 7.50693 2.48224 14.219 -241 1 13.4328 18.4778 5.70681 16.0844 -0.193399 -6.38488 -242 2 12.6986 0.421386 5.55211 -13.5651 7.65576 -7.58054 -243 2 13.084 17.8957 6.37412 -0.0453673 -15.2248 15.7361 -244 1 -0.0111344 2.60704 0.305045 25.2129 -30.2702 8.72131 -245 2 17.7164 2.72495 0.164021 -32.2143 -6.6311 -9.93678 -246 2 0.303096 3.48034 0.225751 24.1306 33.5707 -2.06333 -247 1 12.8325 10.9421 9.75806 8.08682 -36.6012 3.93532 -248 2 11.88 10.8422 9.79419 -10.8426 11.3849 -4.95145 -249 2 13.0795 10.0004 9.94273 0.259667 22.5692 -5.0531 -250 1 0.642026 12.1683 11.0609 4.45464 6.09796 -5.6804 -251 2 18.3356 12.2213 11.2584 6.06715 1.14224 4.76964 -252 2 1.15053 12.4132 11.8471 -8.72956 3.82018 2.8882 -253 1 5.19121 7.35128 13.362 14.2217 -1.26987 2.88721 -254 2 5.71731 8.09811 12.9969 -6.96977 -10.5111 6.72344 -255 2 5.67215 7.04852 14.1611 -4.50302 8.90065 -9.08298 -256 1 1.17753 6.82665 11.884 -6.96202 23.1207 3.27017 -257 2 0.332868 7.13942 11.4836 19.3553 -6.8941 9.30012 -258 2 1.59694 7.61812 12.3119 -7.65201 -17.5731 -13.8958 -259 1 15.4801 9.74186 12.3501 8.02403 -36.537 -7.5848 -260 2 15.2771 10.6331 12.1319 -8.61126 25.0623 0.312061 -261 2 15.6595 9.70704 13.2832 1.37326 2.5629 11.9963 -262 1 16.5169 12.594 5.50965 10.4637 -15.548 10.5874 -263 2 16.3074 13.4879 5.77305 -4.76715 16.3332 -4.64473 -264 2 16.4013 12.5274 4.55501 -3.26126 3.70708 -8.86796 -265 1 6.31292 9.82321 0.0853393 -0.254663 19.8779 15.0366 -266 2 5.47299 10.2624 0.316114 7.63969 -1.93852 0.671735 -267 2 6.95815 10.0698 0.784254 -6.58085 -1.04763 -9.09577 -268 1 12.2316 6.09819 4.0135 -11.5327 11.7492 -3.18772 -269 2 12.1819 6.93481 3.49894 6.0574 -18.2652 4.97925 -270 2 11.3139 5.7855 4.02535 4.75129 -2.10791 -0.415098 -271 1 0.346102 12.8439 0.0895734 -4.86896 0.353582 5.39062 -272 2 18.7507 13.4631 0.799834 -0.48412 -1.67542 -1.66039 -273 2 18.3682 13.0274 18.0218 -2.69393 2.08889 -5.2677 -274 1 3.5489 0.022651 8.64264 14.8213 -2.21723 6.15117 -275 2 3.34146 18.2537 7.79412 -1.37888 1.54429 -1.85278 -276 2 2.69807 0.312924 8.99074 2.91061 0.134312 -8.36673 -277 1 7.48275 17.4677 4.49597 -9.82961 -11.4008 2.47905 -278 2 7.76172 18.3639 4.65831 -0.473756 11.2371 0.709742 -279 2 7.61951 17.3416 3.55584 -1.72206 -2.44101 -5.98946 -280 1 9.27482 17.1419 12.2002 -29.9673 17.8198 -3.75997 -281 2 9.29449 16.2474 11.8858 2.76409 -17.0257 -9.00951 -282 2 9.96887 17.232 12.8306 24.004 1.27191 14.3563 -283 1 13.3881 13.0638 7.94543 23.8544 1.05207 16.0454 -284 2 13.4911 12.3591 8.61055 -7.80977 1.42534 -8.25381 -285 2 14.1677 13.6583 8.10929 -22.3675 -6.64423 -7.05202 -286 1 14.8196 2.98416 15.4059 10.9247 4.82989 11.3692 -287 2 14.1977 2.30622 15.182 -14.8004 -11.8419 -2.86461 -288 2 15.3715 3.04555 14.6288 11.3419 0.403673 -8.50968 -289 1 9.89007 15.644 16.9507 -0.476448 -13.1737 2.9886 -290 2 10.2689 14.811 16.6236 0.33136 1.14394 -2.50282 -291 2 9.50974 15.3862 17.8064 -0.51987 6.75584 -0.702029 -292 1 11.2404 8.49746 16.6126 -11.0388 -24.1902 -5.6141 -293 2 10.5493 7.95233 16.1656 11.7734 11.5748 6.95591 -294 2 11.5411 7.95338 17.3605 -0.459906 4.27214 -6.12679 -295 1 3.94653 18.1828 16.8275 -12.5536 19.575 -10.0724 -296 2 4.49583 17.6028 17.3635 4.26127 2.6886 8.36922 -297 2 3.95977 0.456308 17.1729 5.72776 -19.9128 0.46306 -298 1 2.2132 4.22212 8.91052 -3.52394 3.62108 -17.0138 -299 2 3.14576 4.09878 8.74947 8.67559 -2.34434 0.767855 -300 2 2.06536 4.03466 9.83165 -0.817379 -1.75645 17.2153 -301 1 9.87247 10.3712 9.74928 14.7683 -30.296 -5.49075 -302 2 9.62147 11.2221 9.45607 -13.6864 32.2476 -14.4563 -303 2 9.99394 10.4206 10.6874 0.365841 -1.43755 21.5864 -304 1 9.68376 0.92477 10.8522 -9.86416 -7.8375 -9.37303 -305 2 9.18791 0.169256 11.2055 11.1043 -0.796798 3.35444 -306 2 9.09399 1.23638 10.1435 10.2069 6.90097 4.69651 -307 1 9.16769 15.091 10.1956 22.4355 7.87639 6.21774 -308 2 8.9696 15.9691 9.88131 -3.17938 11.9605 -8.33522 -309 2 8.32743 14.6622 10.1389 -19.5916 -16.662 -1.08184 -310 1 0.85922 9.69743 10.2442 32.6336 -47.5631 -25.4673 -311 2 1.02374 10.6105 10.3992 -2.53948 25.7241 9.50189 -312 2 1.72313 9.35148 9.87448 -35.4256 9.68482 16.6576 -313 1 17.0256 4.81986 8.08308 31.6348 -31.2729 -9.48192 -314 2 16.3215 5.37214 8.33224 -31.3655 27.4802 10.3117 -315 2 16.9319 4.0155 8.6004 0.768816 2.34372 -1.45333 -316 1 14.8081 14.6794 0.153243 -2.85725 -11.5952 -11.9613 -317 2 15.2092 15.2804 0.771003 11.383 9.73034 15.7651 -318 2 14.0408 14.3115 0.591288 -7.92269 -3.99881 6.06231 -319 1 3.80416 11.0019 9.56526 0.623941 6.68377 2.11405 -320 2 3.77619 11.4642 10.4186 -0.043788 -6.16761 3.62327 -321 2 3.31763 11.5705 8.95624 -4.54045 6.84371 -3.4313 -322 1 11.3158 10.7476 1.45776 10.9951 -9.43983 2.74041 -323 2 11.5252 11.5694 1.01773 6.8042 14.5185 -3.76913 -324 2 10.3718 10.6573 1.35733 -14.9091 -3.38451 -2.45366 -325 1 13.1832 7.19978 12.6897 5.92706 -14.8401 5.32281 -326 2 14.1145 6.87754 12.7085 -13.0936 9.37511 -3.26372 -327 2 12.6462 6.38983 12.7968 5.91866 7.22274 -2.53959 -328 1 9.61767 1.88189 0.936979 -6.6056 8.12678 -33.3335 -329 2 8.75647 1.76915 0.468433 15.5153 -2.73343 13.4493 -330 2 10.2273 2.17983 0.230861 -6.38326 -0.489196 14.1696 -331 1 10.6523 13.47 4.56634 -17.7163 6.61907 -5.84307 -332 2 11.5562 13.1849 4.68206 11.5009 -9.86279 4.07703 -333 2 10.5151 14.0877 5.29021 -1.44258 0.681598 7.9468 -334 1 14.5213 1.69385 10.9785 0.412416 12.5139 1.3055 -335 2 15.3159 1.33414 10.5754 1.96072 -4.24727 -0.900333 -336 2 14.7412 2.63918 11.0728 -6.13642 -3.41388 -3.76294 -337 1 14.5042 12.0777 11.6111 -12.2061 0.510996 31.5423 -338 2 15.1827 12.4648 11.0978 29.2487 15.6657 -21.0239 -339 2 13.909 11.6953 10.9807 -16.843 -4.29027 -12.6849 -340 1 8.18401 5.11068 9.87002 -0.676892 -7.65738 -3.35075 -341 2 7.33939 5.06675 10.3357 0.521056 4.21206 1.1001 -342 2 8.29842 4.21721 9.50312 -0.00697362 5.6522 3.71152 -343 1 1.5768 16.9623 18.4443 13.7844 -6.06932 -11.1938 -344 2 2.08688 17.3314 17.6994 -1.29344 -1.55823 6.9248 -345 2 1.72478 16.0021 18.3853 -4.19272 5.84443 -4.03385 -346 1 1.47359 17.3466 15.3156 -41.3862 18.9515 21.4522 -347 2 1.38751 18.1942 15.8376 11.356 -22.4463 -17.1221 -348 2 0.531998 17.0202 15.2731 27.9598 4.08453 -2.72162 -349 1 3.56251 5.80266 6.06315 1.23781 -30.1986 0.952301 -350 2 2.9922 6.42371 6.50913 -3.22231 11.6367 6.59476 -351 2 4.22501 6.28135 5.5614 1.05528 7.23928 -6.44245 -352 1 12.5723 9.4951 14.2463 -14.1947 49.7353 4.36555 -353 2 12.9086 8.77822 13.7576 17.8642 -40.1771 -16.3075 -354 2 12.2963 9.16979 15.1004 -1.36164 -11.5003 11.0357 -355 1 4.07044 15.2648 6.99086 -8.22484 -15.5272 10.3185 -356 2 3.65725 16.0904 6.74002 -9.77102 8.77549 -2.61135 -357 2 5.00026 15.4315 6.88928 20.0063 2.47059 -3.54324 -358 1 0.744606 8.73408 15.0763 0.0218964 -5.95646 -3.10884 -359 2 0.519262 9.66197 15.1074 -7.84082 12.7234 2.89932 -360 2 1.47025 8.73132 14.4431 5.87969 -4.51966 -2.6491 -361 1 12.9306 8.27919 10.1905 8.08936 2.40022 19.7343 -362 2 13.779 7.90886 9.87037 -9.22858 -4.32337 9.26771 -363 2 12.8604 8.07471 11.1624 7.69549 -2.50096 -25.1681 -364 1 15.3235 7.85492 3.5497 18.4153 32.411 -54.1913 -365 2 14.4745 7.6657 3.15314 -16.0822 -13.4855 9.94503 -366 2 15.5116 7.64082 4.44166 -12.2255 -21.7424 34.152 -367 1 17.2256 6.71185 18.6385 13.0601 3.46678 -1.24204 -368 2 16.7837 5.9846 0.423329 -10.4159 -11.046 2.92977 -369 2 16.5307 7.32814 18.3852 -6.78357 2.8142 -3.2779 -370 1 8.8964 6.96848 7.83902 16.0931 16.0227 -2.80611 -371 2 9.83265 7.28699 7.8278 -17.1093 -4.77101 0.707558 -372 2 8.79691 6.46408 8.64714 -0.939429 -8.3316 9.69843 -373 1 12.4084 0.523138 1.23768 -2.06115 0.0733923 -7.11266 -374 2 13.1872 0.998726 1.54472 7.23891 -2.91784 -1.02165 -375 2 12.4662 0.537618 0.274809 1.69654 -3.93261 2.5223 -376 1 5.65468 15.0902 14.5334 3.02676 -25.5773 -0.125585 -377 2 4.72407 15.1616 14.7961 0.127409 2.72757 -0.91443 -378 2 5.99013 15.9712 14.3886 3.52657 16.2654 -6.40367 -379 1 3.82399 6.39797 1.75512 3.78691 -6.14258 3.26006 -380 2 3.37829 7.15763 1.38654 -6.41374 16.3556 -5.84968 -381 2 3.97609 6.61981 2.67876 -1.82166 -0.0414506 2.69272 -382 1 3.91801 11.4637 12.3808 6.26728 1.11409 -8.60855 -383 2 4.78798 11.8777 12.4982 -7.30712 -3.21292 -1.54071 -384 2 3.30212 12.087 12.775 -5.64928 0.778082 5.20377 -385 1 5.29676 3.85177 15.8189 3.43828 -31.27 -8.27082 -386 2 6.03967 3.23378 15.6029 -11.8461 12.1043 0.727598 -387 2 5.68429 4.70341 15.931 13.0054 23.274 1.41344 -388 1 14.2193 10.1559 4.56622 -21.9238 17.9967 10.7876 -389 2 14.2923 9.81422 5.45847 5.67938 -3.41822 10.3914 -390 2 14.6614 9.51741 4.03067 14.2685 -12.4061 -15.9356 -391 1 7.6994 17.3598 9.13069 2.58566 -7.07749 -1.38218 -392 2 6.9688 17.7373 9.6086 -11.208 -1.02501 12.7072 -393 2 7.91331 18.0249 8.47917 9.78731 5.09099 -13.1281 -394 1 4.50671 14.5226 3.97805 12.528 -25.4608 -46.8355 -395 2 4.48015 15.4086 4.24602 -0.161492 47.21 12.2969 -396 2 4.35306 14.022 4.74858 -6.07017 -24.5156 30.0525 -397 1 14.1411 7.46132 15.8217 -22.5264 -9.25347 -2.17647 -398 2 14.9826 7.35759 15.4044 20.5288 -0.540355 -7.58788 -399 2 14.3421 7.83921 16.6731 3.72262 6.08742 11.7763 -400 1 2.98184 18.372 1.90579 -20.1648 -30.237 -17.2141 -401 2 2.43548 17.7555 1.32026 19.5303 24.385 16.7936 -402 2 2.33791 0.236975 2.41065 -5.95562 0.980031 -0.0237849 -403 1 7.99445 1.58502 4.53075 18.7977 0.504684 -14.6733 -404 2 7.48712 1.99417 3.8192 -9.17378 0.780153 1.87786 -405 2 8.88078 1.50473 4.13387 -7.12077 1.17171 10.2984 -406 1 2.41951 14.1599 17.7056 22.0207 15.2121 -4.13121 -407 2 1.68443 13.6195 17.9516 -15.3327 -12.8663 8.26013 -408 2 3.18525 13.6986 18.0793 5.57496 -0.0710026 -2.65101 -409 1 0.908587 1.85846 13.8858 -0.0793858 -1.94323 14.6669 -410 2 1.14821 1.59902 14.7928 -3.46921 3.66635 -7.67361 -411 2 18.5942 2.00299 13.9058 4.01903 -0.250224 -6.72878 -412 1 4.32702 0.129386 13.8829 -0.0770511 3.08332 3.55447 -413 2 5.24833 18.5067 13.8286 4.90059 -4.64875 -2.30826 -414 2 4.05486 18.5232 14.7746 -2.81766 -1.27361 1.32354 -415 1 7.27357 0.854459 18.3804 -15.3869 4.3045 -1.1218 -416 2 7.16992 0.518993 17.4624 3.36336 5.55626 15.3605 -417 2 6.40185 1.20099 18.6914 11.5657 -10.6186 -10.5297 -418 1 15.9542 18.4046 13.9208 -25.3022 5.029 -14.7602 -419 2 15.0075 18.5254 13.735 13.8644 -2.42428 -4.09563 -420 2 16.0061 18.5076 14.8614 8.67486 -1.51607 21.0166 -421 1 10.2392 4.55204 16.2801 10.7238 -8.25817 -3.6178 -422 2 11.196 4.37813 16.4864 -24.802 4.89259 -9.76699 -423 2 9.86858 3.73489 15.891 10.2726 5.88423 10.0044 -424 1 15.9238 17.7149 4.45644 2.75189 -23.1215 -12.8271 -425 2 16.5168 18.4535 4.47728 14.6813 18.6917 2.39924 -426 2 15.0936 18.0469 4.76398 -21.0845 8.87368 10.3462 -427 1 6.95648 17.503 13.9077 -51.9825 -4.38955 -3.71365 -428 2 7.39002 17.773 14.6913 25.8751 9.72049 29.5532 -429 2 7.60747 17.4983 13.2335 27.2317 -2.92469 -23.3456 -430 1 13.2071 6.48879 6.54043 12.3601 -8.29587 -18.0485 -431 2 14.1818 6.5258 6.42811 -17.7974 6.95191 3.55269 -432 2 12.8555 6.35956 5.62691 5.37067 1.68412 18.5111 -433 1 7.86742 2.30794 9.39626 -5.35093 5.07188 8.74379 -434 2 7.30782 2.2926 10.1983 5.67726 -4.12754 -5.74363 -435 2 7.33716 1.92062 8.69482 -5.03183 0.0809058 -6.36949 -436 1 15.2078 14.7586 13.7432 0.832397 -4.30074 -2.87903 -437 2 14.8858 14.9257 14.6258 -3.94452 3.16733 11.6107 -438 2 14.9517 15.5204 13.2236 -2.78606 2.09491 -5.66724 -439 1 9.4202 8.34719 3.8485 -22.8652 4.71801 -4.87246 -440 2 10.1988 8.89706 3.87201 15.3465 4.97444 3.28263 -441 2 9.69606 7.44575 4.01411 1.53448 -7.03017 -1.02937 -442 1 17.7384 13.5884 16.4052 -11.7067 -11.536 8.32036 -443 2 16.7673 13.5542 16.377 3.38001 -6.87595 1.27552 -444 2 17.9496 14.385 15.9274 3.88108 14.0768 -7.71607 -445 1 4.90559 10.5521 2.87839 21.3367 -20.8737 -11.4011 -446 2 5.623 10.1254 3.38432 -4.07258 6.62764 -8.01418 -447 2 4.62886 11.2624 3.4373 -4.18877 12.0113 9.86562 -448 1 3.72998 8.3995 9.96949 0.206562 0.552242 5.18998 -449 2 3.80623 9.33185 9.71276 -0.050758 -4.34606 1.0469 -450 2 3.86748 8.41721 10.9275 -4.36654 -3.13592 -2.04235 -451 1 15.965 6.95365 5.95266 -6.26742 1.66997 1.55481 -452 2 16.7698 7.37181 6.25298 11.0034 6.69643 7.83926 -453 2 16.2161 6.06091 5.70554 3.02292 -8.38979 0.185448 -454 1 15.1879 7.19538 9.00463 -16.574 -33.0638 16.9279 -455 2 15.9728 7.55664 9.38717 21.7076 13.0833 8.35481 -456 2 14.9649 7.65827 8.21955 0.87619 20.3483 -26.3308 -457 1 6.20656 12.8742 12.7233 -2.45823 6.18764 -5.3718 -458 2 6.79799 12.2543 13.1384 18.4055 -9.75357 3.10315 -459 2 6.13621 13.6122 13.3363 -4.91508 8.57981 5.63651 -460 1 12.128 4.53555 13.1062 -17.5662 -8.78193 22.9206 -461 2 12.3906 4.63486 14.0411 2.44404 0.930561 -9.75427 -462 2 11.3004 4.01263 13.1714 14.0583 8.15169 -11.9376 -463 1 11.4184 8.10098 7.95437 7.14359 -3.91624 -16.2991 -464 2 12.1028 7.60478 7.4673 -7.16754 1.39876 -0.578178 -465 2 11.8093 8.18067 8.82553 -2.79742 2.89488 8.77133 -466 1 17.0514 10.8651 7.58728 -24.1088 0.784299 26.3012 -467 2 17.8144 10.3384 7.41217 20.5663 -15.9736 -11.9321 -468 2 16.8601 11.4269 6.84052 2.19633 6.48519 -17.1676 -469 1 5.231 18.0993 10.8546 26.455 4.8965 -4.82813 -470 2 4.8195 17.6908 11.6007 -11.7048 -9.88744 14.1218 -471 2 4.63699 18.0004 10.1206 -18.4061 3.17503 -16.8763 -472 1 7.59767 17.4436 1.69759 5.72815 6.19172 -16.2775 -473 2 7.89477 16.6568 1.18579 0.971667 15.0969 7.35096 -474 2 7.65141 18.2352 1.10536 -4.88626 -20.2664 5.47735 -475 1 1.93145 12.9234 13.6206 5.60545 -3.12143 -21.3855 -476 2 1.4749 12.3281 14.2061 -8.56587 -7.9862 10.2726 -477 2 2.17547 13.6903 14.1341 4.19375 11.0678 7.71152 -478 1 9.43748 6.79443 14.8327 33.0335 -30.4644 -7.71462 -479 2 9.91196 6.01751 15.25 -19.5648 18.6507 -3.60269 -480 2 9.7502 6.76156 13.9011 -9.65438 10.9618 10.9707 -481 1 15.2831 4.34212 10.7772 21.179 15.7439 -2.01388 -482 2 16.2293 4.27243 10.5111 -19.8675 -5.23 11.4528 -483 2 15.2971 5.09975 11.4021 -5.00612 -14.3562 -6.14057 -484 1 11.351 6.2072 0.109577 23.6613 28.7979 6.66193 -485 2 11.4872 5.27024 0.0694097 -6.21323 -21.6319 -6.22108 -486 2 10.4676 6.44004 18.4761 -18.3883 -9.25121 -2.88973 -487 1 18.5357 11.4228 14.9398 26.7643 -26.8403 31.1109 -488 2 18.0597 11.723 14.1947 -18.2778 17.0129 -29.9513 -489 2 18.4532 12.1424 15.5699 -5.23995 5.81903 4.32114 -490 1 7.05668 9.28071 7.31234 -6.58466 7.4517 -4.55549 -491 2 6.71011 8.47084 7.6978 -4.31789 -6.13087 1.68327 -492 2 7.98804 9.13135 7.18438 15.6823 -2.37616 0.276954 -493 1 18.324 15.3331 12.2569 -7.46978 -1.64803 5.36971 -494 2 0.564477 15.5946 11.9899 10.9599 1.36641 -5.51497 -495 2 17.7284 15.6281 11.5548 0.957946 6.58656 -2.69515 -496 1 16.4958 4.38611 5.25998 2.69003 14.057 -30.634 -497 2 16.6253 3.88668 6.0538 7.32023 -9.57738 16.711 -498 2 17.3371 4.41488 4.75201 -4.14044 -1.60108 11.4247 -499 1 17.7073 3.15256 10.779 -3.63642 -2.40486 -9.15002 -500 2 18.6235 3.40441 10.9111 8.43018 2.88916 7.88185 -501 2 17.7389 2.35032 10.2471 -2.89329 -5.91517 0.580451 -502 1 12.2813 18.6401 10.1181 2.89516 -35.5496 -8.35074 -503 2 11.4703 0.383955 10.4005 -29.8535 10.9583 6.97968 -504 2 12.9196 0.674429 10.2218 25.4798 25.6209 2.989 -505 1 10.3974 9.74216 12.5073 0.112101 -17.0368 -3.21727 -506 2 11.1947 9.82557 13.039 4.39701 4.68697 5.66162 -507 2 10.3035 8.76836 12.4158 -2.37231 15.8308 -1.56525 -508 1 0.663588 2.73535 7.12598 -12.3374 1.53361 -6.62113 -509 2 0.367817 3.62684 7.37457 5.09588 -7.68469 3.80292 -510 2 0.956045 2.28157 7.92852 1.53616 1.67998 2.79736 -511 1 0.311147 15.2759 6.88171 -13.4592 45.4783 4.03261 -512 2 0.500617 15.614 7.76495 4.81164 -9.60864 4.06796 -513 2 0.558697 14.3764 6.88071 13.8097 -37.6199 -4.57419 -514 1 17.0548 6.97395 15.0744 4.20776 -1.94343 -1.58424 -515 2 17.8177 7.57453 14.9855 -5.12063 -2.20736 -0.0554095 -516 2 17.4111 6.17613 15.4934 -0.113823 0.922547 0.618491 -517 1 9.1503 12.5213 8.01319 -14.1189 2.82879 0.278945 -518 2 9.53356 11.9725 7.3299 10.3093 -11.5802 -1.96405 -519 2 8.24075 12.6139 7.71394 -0.988228 2.45183 6.21614 -520 1 1.17609 1.70844 2.83295 3.23913 -2.31621 -1.89882 -521 2 1.09855 2.22978 2.02752 -9.74566 -1.77621 -3.35395 -522 2 1.86202 2.13223 3.34238 5.26299 8.17365 10.1548 -523 1 4.09291 15.1504 9.8922 18.1507 -7.2721 -6.40054 -524 2 4.03036 15.1629 8.92399 -1.00826 2.87435 -0.463193 -525 2 4.99389 14.8146 10.0732 -8.74469 0.915467 -5.31212 -526 1 7.37772 2.25117 14.7222 3.22505 8.21162 1.39777 -527 2 7.09502 1.54536 14.1374 1.57311 -0.181539 -4.41158 -528 2 7.85635 2.90205 14.1691 -14.4419 -9.06063 9.37489 -529 1 18.4006 14.5833 2.15968 -9.78242 8.50711 -1.4388 -530 2 0.62994 14.8842 2.46282 -4.8788 5.17113 -0.292034 -531 2 17.7517 15.3351 2.17575 17.725 -12.6913 0.414249 -532 1 9.99197 2.68277 12.9223 -2.58103 11.7713 -8.17336 -533 2 9.96789 2.1685 12.101 0.346485 -5.49174 3.23624 -534 2 9.29748 3.35451 12.7936 3.47695 -5.23648 4.96996 -535 1 2.96299 8.91941 13.096 19.2939 -0.203164 0.561242 -536 2 3.4486 9.7527 12.8428 -15.067 -18.0348 7.07188 -537 2 3.65865 8.27445 13.3679 -12.9331 14.6867 -6.35999 -538 1 3.26147 8.578 3.77304 6.38222 5.3653 -9.36202 -539 2 3.78874 9.26676 3.32736 -9.65467 -7.00498 -1.39723 -540 2 3.24393 8.8647 4.68594 3.08129 -4.64857 6.90262 -541 1 5.77287 7.24333 8.61048 -1.78661 -5.00814 9.07462 -542 2 5.68022 6.28289 8.53661 4.0016 -1.85755 -4.86386 -543 2 5.00276 7.50215 9.14094 4.61323 4.45406 -2.92895 -544 1 14.8793 1.52937 1.85035 -12.7334 -14.0835 12.9397 -545 2 14.819 2.16152 2.5876 10.8144 6.55959 -13.4181 -546 2 15.5594 1.73936 1.19754 -2.84827 11.2594 2.6977 -547 1 8.5607 15.0611 0.725284 0.46926 -2.1008 2.83341 -548 2 9.29259 14.9147 1.35885 -7.99161 6.01774 -7.32206 -549 2 7.81927 14.5289 1.05772 1.7687 -2.35649 0.826934 -550 1 15.4921 1.3993 7.20702 14.746 2.01238 2.95597 -551 2 14.8484 0.891915 6.72418 -10.4472 -9.96976 -7.88743 -552 2 15.1077 2.27361 7.28199 -8.00989 7.94424 8.07076 -553 1 5.01058 12.9585 18.4386 -15.8567 -4.4202 8.08993 -554 2 5.4193 13.0053 0.667327 2.46468 -0.195888 1.58163 -555 2 5.59523 13.4446 17.8643 8.60291 1.11734 -4.66644 -556 1 15.4019 8.61725 18.0949 -10.0539 -8.80276 13.7753 -557 2 15.8344 9.23888 17.5182 6.53635 7.63687 -15.5634 -558 2 15.1418 9.16559 0.203922 1.58583 0.47418 3.18719 -559 1 12.0525 3.11208 18.2861 7.73999 -14.4321 9.61497 -560 2 12.4007 2.82569 0.495607 -5.57788 10.1171 1.38067 -561 2 12.4066 2.43321 17.7002 -1.56388 4.26076 -9.69121 -562 1 13.1688 12.6857 5.1494 7.31226 -7.20074 3.10637 -563 2 13.4985 11.8462 4.78426 1.65488 6.62932 1.41885 -564 2 13.3525 12.6203 6.1046 -3.90991 6.43934 -4.24709 -565 1 6.08926 7.21668 0.130178 -1.88627 11.2856 16.2629 -566 2 6.12641 8.19603 18.8427 -2.9512 -23.7133 -6.32338 -567 2 5.32645 6.95656 0.679872 3.54107 -2.60359 -10.7249 -568 1 17.6547 15.8703 14.9132 16.2429 2.82715 17.6162 -569 2 16.6953 15.9075 15.0555 4.78919 3.7515 -14.6122 -570 2 17.9345 15.7768 13.9856 -18.469 -1.14955 -2.42085 -571 1 13.1468 0.885591 16.7291 -10.7864 15.024 2.10847 -572 2 14.1008 0.813897 16.7431 10.5998 -4.62802 3.60151 -573 2 12.8375 18.6536 16.4909 -4.88764 -9.34618 2.57866 -574 1 10.8908 14.4992 7.43136 -2.2343 -7.03539 12.0134 -575 2 10.0835 14.2065 7.92308 22.5278 2.1252 -13.3834 -576 2 11.6003 13.8396 7.60224 -11.7269 11.3777 -3.99947 -577 1 17.6181 8.42363 2.12766 -11.9935 -3.6797 -6.77545 -578 2 16.7343 8.37762 2.55285 14.0369 1.72981 -7.6286 -579 2 17.5632 7.81953 1.35766 3.76606 6.32419 13.0143 -580 1 12.3929 7.83138 2.01819 4.71096 17.5308 0.40727 -581 2 12.1717 8.7272 1.7221 -1.13772 -2.1217 4.67191 -582 2 11.9464 7.25327 1.39471 0.282935 -6.68024 -6.10503 -583 1 12.0275 14.6478 10.4009 38.9809 -24.2439 -10.9711 -584 2 12.337 14.044 9.6932 -4.28518 13.1756 12.472 -585 2 11.1105 14.7441 10.2592 -43.0899 4.37787 -4.57767 -586 1 6.8265 6.93238 15.5327 -27.6581 -7.97269 5.64053 -587 2 7.73103 7.08984 15.3178 26.4357 1.09681 -7.32033 -588 2 6.59533 7.63547 16.1384 -2.46814 3.13878 5.80205 -589 1 7.96021 4.51991 13.281 5.98272 36.635 4.98876 -590 2 7.18773 4.72006 12.7149 7.22552 -5.34662 5.9239 -591 2 8.2239 5.40342 13.6709 -8.7699 -31.8396 -11.1478 -592 1 13.3799 12.1942 14.3144 0.413244 -2.26196 2.0512 -593 2 13.2473 11.2333 14.3131 -4.23433 1.2327 0.0241848 -594 2 13.7366 12.3802 13.4362 1.03232 3.06063 -1.77089 -595 1 14.6196 9.43974 7.2819 12.1284 19.1611 12.5008 -596 2 15.4631 9.9012 7.50833 -13.143 -10.3991 -7.78335 -597 2 13.9498 9.89967 7.80701 0.241302 -5.62146 -3.59828 -598 1 12.6688 16.8855 3.24635 -1.47445 -34.5545 -0.541717 -599 2 12.9124 17.3724 4.01195 4.0393 16.1159 25.6755 -600 2 12.6994 17.4999 2.53895 -2.71389 24.0914 -25.4271 -601 1 1.00064 7.12258 17.3474 25.8989 -13.4919 10.9638 -602 2 0.199171 6.81692 17.7654 -17.9333 6.12878 2.90109 -603 2 0.781412 7.72916 16.646 -4.92956 7.36441 -13.84 -604 1 12.947 4.88013 15.7213 -21.2986 7.3754 -0.931645 -605 2 13.7769 4.45629 15.8524 19.8874 -20.9291 -0.114876 -606 2 13.1805 5.80207 15.7513 2.74699 20.2475 2.05037 -607 1 2.36441 3.38825 5.1495 13.4973 -9.76059 -50.575 -608 2 1.87697 2.96062 5.81278 -27.3053 -18.1487 33.2377 -609 2 2.7907 4.09602 5.58982 16.1263 32.9476 11.4061 -610 1 8.23368 10.9868 13.6471 -16.5646 12.9957 -7.98974 -611 2 8.32411 10.9316 14.5895 -0.490848 -4.77914 16.6738 -612 2 9.07298 10.6867 13.3074 11.7511 -8.07538 -9.61613 -613 1 13.0107 1.52025 13.2616 -13.3177 -0.0328213 18.9383 -614 2 13.4383 1.61013 12.4179 13.267 -2.68379 -13.3373 -615 2 12.5185 2.34771 13.3673 3.11016 -7.04189 -1.75869 -616 1 6.59377 13.5764 2.15874 -7.12741 11.9903 -27.1264 -617 2 6.00679 13.9468 2.8128 -10.8754 6.0075 10.3445 -618 2 7.2163 13.0692 2.66145 9.56033 -10.8956 7.78491 -619 1 15.8548 6.42593 12.5881 24.8624 13.3217 16.2273 -620 2 16.4838 6.96617 12.0488 -16.1868 -9.65605 6.77151 -621 2 16.2214 6.49686 13.512 -7.09801 -2.27572 -23.2114 -622 1 16.7956 0.692247 9.54535 7.46915 17.7641 2.49637 -623 2 16.5452 18.5156 9.96298 -0.0131793 -20.516 -0.238231 -624 2 16.2976 0.789947 8.72228 -2.61192 -2.24486 -4.75056 -625 1 6.11318 11.627 8.27064 9.91462 44.2797 -2.20509 -626 2 5.35292 11.2978 8.70378 -29.3613 -6.33495 17.8965 -627 2 6.52877 10.8496 7.97791 23.4734 -34.8725 -13.0112 -628 1 2.81389 8.67751 0.381383 10.1752 -8.74242 -1.84173 -629 2 2.33278 8.32184 18.2713 -4.10181 -2.8979 1.44899 -630 2 2.25425 9.35695 0.757627 -6.74555 6.18422 5.10447 -631 1 10.1136 10.3815 6.5683 -3.97178 -1.84722 1.40214 -632 2 10.6776 9.73953 7.0164 -1.23094 -3.31757 4.86865 -633 2 10.3499 10.3203 5.64027 4.41826 3.29106 -4.73543 -634 1 6.84727 15.7748 6.6764 -14.7135 -11.7826 9.04786 -635 2 7.02398 16.1904 7.53289 5.38031 2.81892 -3.47781 -636 2 6.91879 16.4549 5.99719 9.07918 3.78678 -4.16926 -637 1 6.52182 12.8956 5.7943 0.541827 3.55761 1.99739 -638 2 6.55778 13.7774 6.19915 3.14226 -1.33255 -2.96851 -639 2 6.13082 12.3068 6.44859 -0.859963 5.03094 3.84811 -640 1 16.7567 12.5314 9.76383 -4.64367 0.23861 8.75508 -641 2 16.9908 11.8798 9.10281 -4.06168 -8.34407 -5.30318 -642 2 17.2898 13.2837 9.5332 2.7418 12.1851 0.697411 -643 1 6.23186 2.86269 2.75104 2.97881 8.48666 -1.38882 -644 2 6.52094 3.78037 2.52233 -11.0321 -17.6889 -1.77294 -645 2 5.63962 2.52843 2.04764 8.59188 6.36028 2.68011 -646 1 10.7835 3.03466 3.2504 -5.97107 -1.61798 -4.71292 -647 2 10.2628 3.82076 3.45136 1.61481 0.158577 0.983482 -648 2 10.306 2.59283 2.52669 4.73542 2.88639 2.9637 -ITEM: TIMESTEP -80 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.82629 6.70343 17.8553 -15.1071 8.15122 13.6853 -2 2 7.99416 6.85162 18.349 10.9787 -1.12299 -6.8679 -3 2 8.57507 6.09547 17.1643 3.5075 -8.11573 -6.04158 -4 1 0.137192 8.33532 6.74353 12.0191 -20.4001 -6.39938 -5 2 0.250097 8.10589 5.79669 -2.0008 6.10915 10.6578 -6 2 0.653601 7.63933 7.2162 -12.3825 18.3147 -3.0068 -7 1 8.60149 0.29664 6.93203 12.1667 -9.17994 12.1946 -8 2 9.52501 0.228788 6.64808 -5.75422 4.1152 -0.42095 -9 2 8.21226 0.977159 6.3883 -5.16274 6.48178 -7.47064 -10 1 6.50463 1.68869 11.7262 -16.2706 -7.92373 -2.85274 -11 2 5.9813 2.3145 12.2428 -2.71472 -2.47934 -1.80386 -12 2 5.86927 0.986784 11.4354 16.7384 10.0214 6.53226 -13 1 6.9131 5.55027 2.37535 3.77295 -5.39511 9.11334 -14 2 6.43692 5.84081 3.17655 -0.921031 3.98795 -14.1822 -15 2 6.69543 6.14979 1.6478 1.12895 -1.48609 4.32855 -16 1 16.196 10.2371 16.1388 -31.5516 2.77844 19.9706 -17 2 16.8915 10.3643 15.5412 37.4 6.14414 -23.2997 -18 2 15.8469 11.1288 16.3108 1.55641 -10.2432 -3.37881 -19 1 10.775 14.9631 2.31622 -5.5944 -0.094079 7.63582 -20 2 10.598 14.4521 3.12767 5.78422 3.02899 -5.84463 -21 2 11.1066 15.8146 2.64245 2.43259 -3.51347 -1.1859 -22 1 17.165 8.21001 10.8825 14.1674 -5.9779 -9.25967 -23 2 16.5809 8.83567 11.3092 -8.03296 12.2385 6.15632 -24 2 17.9797 8.71133 10.6858 -5.20793 -0.650283 -1.86008 -25 1 14.6097 15.9558 16.401 14.8916 -7.54315 9.24646 -26 2 13.6847 16.2494 16.4321 3.25844 -2.02272 0.00765398 -27 2 14.8063 15.4932 17.2527 -13.7355 5.39716 -16.4095 -28 1 12.117 13.3155 0.580411 -1.24587 -0.207976 3.78722 -29 2 11.7909 13.4576 18.3369 0.57388 -2.32058 -15.0609 -30 2 11.6242 13.9531 1.10951 4.78037 0.383607 7.31905 -31 1 9.34228 5.488 3.85121 53.6451 1.51077 14.3512 -32 2 8.91013 5.51861 4.6996 -19.4462 -5.34697 10.1126 -33 2 8.70488 5.4763 3.16894 -36.9473 -0.666442 -22.4182 -34 1 1.61615 3.95559 11.5848 -7.57046 15.5603 -11.9076 -35 2 1.66987 4.89506 11.8258 -4.51216 0.523906 3.16779 -36 2 2.10845 3.4705 12.2371 10.5178 -10.3797 12.993 -37 1 2.10284 6.89743 8.15957 -0.837321 -0.675751 7.8246 -38 2 2.47895 7.28827 8.96165 1.07034 3.30836 -6.30935 -39 2 2.071 5.95646 8.37348 -2.86121 -4.48577 -0.939591 -40 1 5.32433 4.44486 7.86972 -1.34052 23.2477 3.45796 -41 2 5.46877 3.5107 7.98026 -0.0649778 -19.4924 -5.7669 -42 2 4.70188 4.60713 7.1427 0.919422 -2.43856 3.29815 -43 1 3.32435 2.88678 17.4197 -1.88929 -9.6261 16.8991 -44 2 4.05816 3.29734 16.977 14.1471 9.33662 -16.3951 -45 2 2.86083 3.59453 17.8818 -3.32176 6.96255 1.50629 -46 1 7.47308 5.51417 6.17701 6.20604 7.73103 -29.885 -47 2 7.95124 6.07722 6.78768 5.01174 3.41934 10.0258 -48 2 7.09189 4.79949 6.66958 -7.20601 -9.71089 14.7057 -49 1 9.80158 6.99902 12.0223 -22.5784 -4.24274 -21.2019 -50 2 10.1069 6.1805 11.5916 -0.00510546 9.67372 7.70676 -51 2 9.03411 7.28611 11.4542 20.6129 -4.31213 14.2424 -52 1 14.1091 3.78361 8.12438 -15.7573 21.5912 -11.6445 -53 2 13.5201 4.50308 7.77049 18.8532 -19.0333 8.38218 -54 2 14.3457 4.04736 9.022 0.199067 1.13361 3.22772 -55 1 4.50215 17.2152 3.88612 2.87802 -1.37968 10.5361 -56 2 5.34021 17.6676 3.86593 13.8498 1.95887 5.68097 -57 2 3.97594 17.6789 3.24294 -11.45 0.485265 -14.6478 -58 1 16.2741 16.534 10.4726 -5.67102 -12.8311 -21.8814 -59 2 15.486 16.5615 11.0293 -1.33881 1.5325 0.205711 -60 2 15.9943 16.0074 9.67798 5.00326 13.1852 19.554 -61 1 1.98121 4.83276 0.125548 -2.90665 -21.863 0.561723 -62 2 2.62989 5.11603 0.769738 5.61812 10.8419 9.00632 -63 2 1.75087 5.59897 18.2498 0.950825 13.4626 -6.91806 -64 1 11.2654 13.2951 16.4195 -4.34554 -2.68737 -1.67212 -65 2 10.7681 12.4683 16.4833 0.87563 -1.05494 5.85319 -66 2 11.8765 13.1105 15.7039 6.19214 3.55339 -6.25188 -67 1 10.1028 10.9035 16.8331 17.2825 8.49241 1.71185 -68 2 10.5205 10.0327 16.7798 -0.767632 10.3686 4.9905 -69 2 9.17724 10.7556 16.7424 -24.4211 -4.37906 -2.41009 -70 1 11.8507 17.4827 13.4696 7.63981 7.03239 -1.88788 -71 2 12.509 16.94 12.9947 -8.02315 8.08552 1.57387 -72 2 12.1795 18.4053 13.408 -3.08283 -9.25718 -0.840972 -73 1 6.44601 9.4433 12.2773 8.37995 -15.986 -34.1351 -74 2 7.00514 9.1357 11.5138 -12.9725 10.8563 23.5312 -75 2 7.03346 9.94503 12.8365 5.04668 8.97956 7.26084 -76 1 16.2979 12.8575 2.71922 -11.7369 16.949 2.19382 -77 2 17.1652 13.221 2.45954 -10.8006 -1.31331 4.0939 -78 2 15.6758 13.6404 2.78783 18.0783 -23.2667 -2.52892 -79 1 0.707968 12.7192 5.87585 -9.46746 -3.17244 -7.34712 -80 2 1.05314 12.7932 4.98248 12.8843 -1.39545 -4.60697 -81 2 18.4375 12.4692 5.68303 -3.12969 3.97578 10.4064 -82 1 5.29671 16.347 18.4316 -9.43352 6.10902 0.949816 -83 2 5.62099 15.5668 17.9615 5.22561 3.70018 3.69326 -84 2 5.92538 16.5961 0.477291 0.486221 -4.47534 -1.04063 -85 1 0.707184 7.70367 4.119 -51.5024 -35.8612 26.1825 -86 2 0.14378 7.97362 3.40377 -12.5647 4.97441 -12.5535 -87 2 1.50957 8.08535 3.91273 65.7491 26.1316 -14.6887 -88 1 3.20348 9.03456 6.50534 -36.9666 27.611 -24.7826 -89 2 3.63112 8.56754 7.174 27.0077 -25.2244 35.3222 -90 2 2.25579 8.96355 6.72902 9.17057 2.1904 -6.46933 -91 1 7.27937 10.3761 16.2413 -0.230914 -4.48303 6.76598 -92 2 6.52755 10.9587 16.1419 -2.56448 5.11938 -3.06937 -93 2 7.11485 9.96393 17.0986 -0.495486 0.80288 1.59662 -94 1 11.0332 0.910989 5.0177 -6.88619 -3.17881 -8.23488 -95 2 10.972 1.75479 4.54866 7.92386 3.49104 7.17877 -96 2 10.6826 0.325395 4.32946 5.79259 -4.26916 6.55693 -97 1 4.2654 2.89302 13.1773 0.694211 20.6748 -2.64105 -98 2 4.39238 3.45448 13.9576 1.0821 -9.7456 0.782255 -99 2 4.16489 1.98946 13.4871 -0.702651 -10.6992 3.24412 -100 1 8.43419 10.272 1.79599 3.30535 -21.7188 -14.6566 -101 2 8.19585 10.8779 2.48837 0.0509316 11.2873 19.613 -102 2 8.53541 9.39344 2.20281 2.46081 9.96427 2.84146 -103 1 10.2486 1.68186 15.4597 -14.9494 5.38019 -3.47887 -104 2 11.0964 1.37036 15.7536 17.388 -0.916576 -1.92962 -105 2 10.2694 1.89097 14.5087 2.57313 -1.10767 6.05091 -106 1 2.6143 12.7739 7.92246 0.947228 -0.997667 -1.9326 -107 2 3.16975 13.4683 7.54148 -0.729705 2.73148 -0.490338 -108 2 1.96608 12.5591 7.23618 1.36975 0.244975 0.56737 -109 1 3.86268 11.7535 5.00307 -14.4028 -3.16999 8.33757 -110 2 3.70976 11.1475 5.74815 1.12966 3.67823 -8.44516 -111 2 3.06255 11.7297 4.44022 7.7842 4.67892 9.37694 -112 1 6.76061 14.5167 16.9537 -0.888094 -7.58336 -2.84579 -113 2 7.48488 15.1306 17.0914 4.64858 -1.1877 -1.93173 -114 2 6.56705 14.5225 16.0035 -2.02875 6.77169 3.29706 -115 1 14.2034 14.5245 3.20058 -0.0398844 -12.3077 5.38397 -116 2 13.8793 15.4221 3.34301 -5.62621 -2.27359 -1.58508 -117 2 13.7959 13.9448 3.87781 2.42748 11.415 -6.18352 -118 1 8.70505 18.0887 16.0942 -64.5065 -8.09898 -3.91687 -119 2 9.21396 17.4083 16.5058 25.0639 -11.349 2.42178 -120 2 9.16407 0.206988 15.7928 30.835 22.2192 -2.21878 -121 1 4.63692 1.68417 4.88655 37.1566 -9.63698 -3.58798 -122 2 3.87701 2.22405 4.82391 -30.2785 19.7734 3.84799 -123 2 5.28246 2.1077 4.29595 -5.87377 -5.36693 3.35208 -124 1 15.0131 12.6297 16.4887 -20.293 3.22713 36.7225 -125 2 14.5244 12.6173 17.3484 21.3151 5.53737 -15.2497 -126 2 14.2857 12.586 15.869 -0.208138 -0.973548 -24.0506 -127 1 15.729 18.4304 16.8576 -8.95075 23.4819 -17.3869 -128 2 16.2245 18.5231 17.6612 15.7889 -2.20706 14.0604 -129 2 15.4698 17.5226 16.786 -7.06215 -23.0828 1.02158 -130 1 1.394 1.31209 16.6703 -16.8241 -3.16738 2.04331 -131 2 2.15084 1.87826 16.8449 0.715689 -4.34048 -2.49358 -132 2 0.715561 1.66179 17.2756 6.00571 -5.18273 -5.07353 -133 1 18.2252 4.3402 15.9772 -8.55569 -2.73 -13.6324 -134 2 17.823 3.76125 15.3072 5.10239 5.23383 8.49054 -135 2 0.492866 4.4785 15.7127 2.39871 -0.864238 1.29175 -136 1 12.1265 17.032 16.1255 -25.5416 -7.58495 15.967 -137 2 11.3669 16.5924 16.5691 16.6277 5.86514 -1.80192 -138 2 11.8242 17.0598 15.2127 8.00105 4.8532 -10.0676 -139 1 16.1291 2.68344 18.211 0.375456 -13.3929 15.5569 -140 2 15.6138 3.3874 18.6109 -0.098248 15.4546 -4.83257 -141 2 15.8549 2.61026 17.3068 -10.5356 1.78345 -20.9571 -142 1 6.60182 13.7939 10.068 9.2492 3.65708 4.18485 -143 2 6.57275 13.4224 10.9661 -3.78941 -3.14938 -5.19226 -144 2 6.71396 13.0652 9.44214 -7.17216 -3.95227 2.85982 -145 1 10.1302 18.5571 2.70452 28.7428 2.61674 -1.08827 -146 2 10.6588 0.134354 1.90491 -8.77267 0.774664 16.1596 -147 2 9.28539 18.2699 2.40893 -22.5926 -9.32297 -10.0302 -148 1 3.0625 17.7033 6.15366 -32.6923 -3.28618 14.6113 -149 2 2.13754 17.6931 5.7562 38.9757 -0.864197 5.33283 -150 2 3.7049 17.7316 5.44436 -0.964713 0.371031 -13.1926 -151 1 12.6087 16.7853 7.93012 21.3772 -3.32102 -23.3093 -152 2 11.8409 16.2517 7.71322 -11.0279 -6.8961 6.738 -153 2 12.4183 17.3739 8.65053 -14.1479 13.0972 16.1976 -154 1 14.9031 15.2939 8.2802 -30.4011 23.5185 11.3145 -155 2 14.1656 15.9721 8.20757 23.4522 -23.8051 0.0341398 -156 2 15.3634 15.3182 7.4362 3.9964 4.48103 -1.46252 -157 1 17.8706 18.2596 0.245663 2.0948 -17.0514 -11.0411 -158 2 18.6148 17.6985 18.5349 -15.5847 20.6608 16.06 -159 2 18.229 0.448391 0.574358 6.37924 -1.254 -0.87753 -160 1 0.806491 10.487 1.42673 -7.2326 -9.98023 10.4462 -161 2 -0.00161399 9.98055 1.66044 10.6613 4.25192 -4.69396 -162 2 0.557346 11.1929 0.820979 -4.09494 2.43397 -4.83249 -163 1 1.83456 12.2686 3.29043 -8.34448 2.57963 -8.45001 -164 2 1.36787 11.5875 2.7525 13.033 10.6511 2.37549 -165 2 2.15971 12.967 2.6794 -8.27007 -10.3927 7.15994 -166 1 0.688934 17.2807 4.96532 -1.28513 13.5074 -14.6034 -167 2 -0.0176841 17.9487 5.11769 8.40666 -17.1979 3.35047 -168 2 0.596617 16.4414 5.43231 -12.6974 4.79178 9.39957 -169 1 1.09014 0.907525 9.3383 6.29421 1.3921 30.3575 -170 2 1.25758 0.656293 10.2983 -10.9635 5.07818 -25.2558 -171 2 0.281108 0.475301 9.05696 -4.67463 -4.0945 4.23309 -172 1 16.7684 2.39691 13.3495 9.61769 42.5491 2.72371 -173 2 16.904 2.78957 12.4595 -0.731435 -13.0756 10.2936 -174 2 16.527 1.48948 13.2642 -5.98641 -27.7824 -4.48506 -175 1 2.71373 15.9459 12.053 -3.75115 0.267025 20.4445 -176 2 2.98439 15.5717 12.9162 -2.14108 4.62523 -16.3505 -177 2 3.30112 15.6057 11.3695 4.80572 -2.00813 -1.58569 -178 1 16.3912 15.5658 6.1364 -18.5193 -23.7813 -1.39285 -179 2 17.3153 15.4712 6.31079 23.2449 0.130836 8.54259 -180 2 16.3263 16.278 5.5153 -3.20698 17.7917 -15.4301 -181 1 5.73039 5.21537 11.7967 -2.24013 5.33831 8.85226 -182 2 5.58704 6.03693 12.3192 -1.36073 -15.5687 -10.3459 -183 2 5.0707 4.59019 12.1393 4.45693 0.898588 -6.68224 -184 1 15.134 4.90094 0.781902 20.2218 -12.3751 4.08616 -185 2 14.9115 4.68422 1.69179 -1.28767 -2.72314 10.4735 -186 2 14.3889 5.35469 0.437757 -23.5901 14.4279 -10.7703 -187 1 16.3592 16.4594 1.89384 25.1746 19.6936 -18.9686 -188 2 16.2469 16.8 2.79117 -6.86302 3.67352 0.481682 -189 2 16.829 17.1783 1.36994 -16.7874 -21.2348 17.437 -190 1 0.175681 4.85349 3.94905 -38.6563 1.2533 -4.07114 -191 2 0.373462 5.78529 3.89581 11.5619 13.3417 2.94095 -192 2 0.969717 4.36237 4.02266 30.2668 -11.0427 7.4994 -193 1 2.99204 15.0813 15.1763 -0.305205 14.4793 -34.7595 -194 2 2.88713 14.6595 16.0135 -9.94348 -6.29569 26.5741 -195 2 2.4481 15.8945 15.1967 6.07768 -3.34342 6.9782 -196 1 1.12287 14.6661 9.5226 42.1359 23.511 16.8308 -197 2 2.04871 14.8527 9.88052 -40.3465 -4.39318 -17.9218 -198 2 1.08708 13.7187 9.50981 -4.88478 -15.9854 1.2011 -199 1 13.5299 16.5144 11.5405 11.2356 18.9117 4.33104 -200 2 13.1159 17.2557 11.0661 2.81218 -0.6798 2.92705 -201 2 13.1037 15.7572 11.1579 -10.8238 -16.1215 -4.14744 -202 1 4.70977 1.52963 0.718559 3.58248 -24.4192 11.8527 -203 2 4.08939 1.89433 0.0933404 -5.33693 14.3563 -9.66083 -204 2 4.20955 0.796838 1.1277 3.32575 8.01941 1.68952 -205 1 1.50238 18.6141 11.9042 -1.38031 13.5472 16.8753 -206 2 1.45658 0.425239 12.7856 -0.241625 -6.75063 -24.7438 -207 2 2.14944 17.9089 11.9973 -1.06457 -6.06855 3.15913 -208 1 11.4462 10.1354 4.10554 -27.8103 0.519562 13.0103 -209 2 11.5399 10.6236 3.29381 1.04561 4.25273 -17.1067 -210 2 12.3232 9.96387 4.39943 30.3669 -4.33072 3.08727 -211 1 8.16113 12.1728 3.80004 4.97071 -3.14572 14.2587 -212 2 8.9952 12.5305 4.11747 11.4774 1.91239 -11.4095 -213 2 7.64202 12.24 4.61417 -11.8418 -2.63078 -6.07404 -214 1 14.5844 4.03291 3.36716 -4.11232 -3.55002 -24.3582 -215 2 15.2517 4.33672 3.97304 10.7234 0.0718586 14.5399 -216 2 13.7453 4.32617 3.71649 -8.9869 4.72015 4.68372 -217 1 5.72064 1.64489 7.5839 32.9059 28.6425 0.0988457 -218 2 5.06921 1.12259 7.98588 -34.2591 -28.2453 24.4599 -219 2 5.39575 1.74393 6.6993 -3.28926 -2.3453 -25.2911 -220 1 17.8815 1.07824 4.83341 -4.77439 -8.44394 -0.469265 -221 2 18.4195 1.29399 4.06103 3.32925 4.9906 2.38586 -222 2 18.1973 1.60106 5.58304 1.56226 2.04575 -0.708791 -223 1 6.854 9.3046 4.53528 10.3956 -9.62802 3.27507 -224 2 6.69426 9.36632 5.492 2.76918 3.19153 -6.51095 -225 2 7.80605 9.0738 4.45229 -13.5827 1.70924 -0.808399 -226 1 2.59539 14.8276 2.04954 -21.4179 -5.20739 -34.911 -227 2 3.34516 14.7063 2.60932 22.2061 -1.352 15.1427 -228 2 2.90646 14.7931 1.11821 -3.29515 2.22824 22.2692 -229 1 17.3057 12.9587 13.1574 -14.3584 11.8265 -1.68619 -230 2 16.4238 13.3017 13.4505 21.6076 -1.54195 -11.2195 -231 2 17.8123 13.7306 12.814 -13.7958 -9.76612 7.37248 -232 1 14.8715 10.5568 1.52593 -13.8049 33.9422 19.399 -233 2 15.3968 11.3309 1.89043 -12.48 -24.7346 -11.1652 -234 2 13.9264 10.776 1.72699 26.333 -7.21409 -8.066 -235 1 5.65075 6.69227 4.53589 -1.16643 0.470211 -4.08107 -236 2 5.90168 7.60385 4.33311 1.92457 3.57872 5.04239 -237 2 6.31691 6.35225 5.15026 1.24698 1.28263 2.78678 -238 1 8.00933 8.29789 10.2803 -8.03608 2.46456 2.45807 -239 2 8.54459 8.86115 9.67988 -10.051 -7.82575 5.32423 -240 2 7.18397 7.98917 9.84875 17.8376 0.213066 -8.74409 -241 1 13.4452 18.4811 5.71348 30.3006 1.0471 -14.1486 -242 2 12.642 0.299737 5.48582 -19.0854 8.92614 -0.688815 -243 2 13.1967 17.7426 6.25238 -10.7462 -10.7439 19.4962 -244 1 -0.0119027 2.59488 0.354931 35.8038 -39.8932 13.3955 -245 2 17.7273 2.51611 0.10594 -24.5443 11.4005 -8.19311 -246 2 0.27212 3.48779 0.285479 3.99253 30.2779 -6.4317 -247 1 12.849 10.869 9.75158 -6.21929 20.5855 -7.88953 -248 2 11.8713 10.9784 9.78619 15.6811 -13.8069 -0.457669 -249 2 13.0615 9.92753 9.83861 -13.7986 2.36182 2.76964 -250 1 0.623186 12.214 11.083 4.78072 12.4497 9.66308 -251 2 18.3291 12.2937 11.2784 -7.07035 -2.86266 -6.1852 -252 2 1.03568 12.566 11.8864 5.16139 -3.44089 -5.05626 -253 1 5.24317 7.35288 13.329 16.5645 10.6427 9.86574 -254 2 5.81232 8.06371 12.9598 -16.2044 -6.02954 3.80806 -255 2 5.63373 7.21351 14.2126 -3.74153 -4.80134 -10.81 -256 1 1.17457 6.8033 11.9036 -23.8679 10.4664 -9.71638 -257 2 0.289623 7.06715 11.5324 26.398 -8.64759 11.7652 -258 2 1.56564 7.61974 12.2537 0.753648 -2.9175 -1.70229 -259 1 15.4919 9.76734 12.3795 0.0614124 -7.36309 3.05776 -260 2 15.0846 10.6319 12.2391 7.36463 -2.83561 -3.47144 -261 2 15.8873 9.82027 13.2467 -0.105969 -0.524429 6.2821 -262 1 16.5022 12.5635 5.51418 5.92626 -4.93161 -13.1981 -263 2 16.3002 13.4761 5.69188 -2.75562 16.3616 9.80459 -264 2 16.3759 12.5305 4.55079 1.66896 -8.7704 1.12914 -265 1 6.31756 9.85145 0.122373 -12.0354 8.37982 6.54531 -266 2 5.4699 10.2439 0.423151 12.3884 -4.45977 -3.2374 -267 2 6.98984 10.1338 0.758446 2.49067 2.04662 0.271789 -268 1 12.1918 6.08954 4.01066 -16.388 -25.9861 2.6766 -269 2 12.1912 6.72626 3.29268 0.559249 7.6643 3.09763 -270 2 11.3251 5.63233 3.94387 14.2823 13.1494 2.08097 -271 1 0.332379 12.8663 0.0441745 0.0508304 2.00456 8.93046 -272 2 18.9019 13.5185 0.756349 -7.27218 -2.99587 0.981784 -273 2 18.3327 13.1573 18.0278 2.80865 -1.79272 -4.8195 -274 1 3.54313 0.0443203 8.66238 11.9606 -6.13667 -3.48184 -275 2 3.32458 18.1774 7.87344 8.237 1.02812 -5.83338 -276 2 2.68777 0.391851 8.89446 -8.31408 9.03305 4.42594 -277 1 7.44404 17.5122 4.49167 0.119683 3.6114 3.91179 -278 2 7.85567 18.3869 4.65486 -14.0238 -13.6963 -7.23825 -279 2 7.39901 17.3877 3.53399 5.58618 2.96743 1.37553 -280 1 9.26713 17.153 12.2094 -20.2295 17.8608 7.81194 -281 2 9.28392 16.3133 11.7674 1.3049 -15.888 -12.5165 -282 2 10.076 17.208 12.7094 15.0452 0.291548 7.10451 -283 1 13.4068 13.0832 7.92217 -6.10698 -2.73533 15.5952 -284 2 13.4694 12.4257 8.66119 -0.459118 13.24 -15.7611 -285 2 13.8946 13.8972 8.17425 4.86633 -17.7849 -1.17812 -286 1 14.7977 2.95386 15.4326 21.7471 11.1646 11.1554 -287 2 14.1505 2.32893 15.1446 -13.9872 -17.9607 -8.38755 -288 2 15.4352 3.02911 14.7173 3.23846 -4.77681 -7.04868 -289 1 9.91022 15.6467 16.9338 -7.88269 11.4297 -3.43074 -290 2 10.0979 14.7902 16.532 6.40878 -6.10819 3.84543 -291 2 9.43747 15.4751 17.7557 1.6004 -7.26983 6.6271 -292 1 11.2148 8.51865 16.6243 -9.14606 -19.2231 -14.9185 -293 2 10.4285 8.06123 16.2547 13.8022 0.848227 5.21642 -294 2 11.6642 7.88268 17.1928 -1.33785 -0.880144 3.29074 -295 1 3.96477 18.2022 16.8388 0.151724 27.8243 14.0652 -296 2 4.47646 17.6367 17.4198 3.54357 -14.0579 0.0762873 -297 2 4.08749 0.446059 17.2373 -6.51294 -16.617 -15.0442 -298 1 2.23636 4.23466 8.90617 11.6474 4.96614 0.176633 -299 2 3.18727 4.06881 8.84702 -5.0902 0.586039 -2.82984 -300 2 2.03755 4.18072 9.84669 -2.61694 -5.47133 1.10155 -301 1 9.89683 10.3797 9.78633 12.6385 -21.4053 -24.2531 -302 2 9.49137 11.1552 9.42946 -10.1833 20.5571 -3.63947 -303 2 9.86232 10.3926 10.7266 0.554165 3.61624 28.8421 -304 1 9.72109 0.91625 10.832 13.6195 9.02414 1.59857 -305 2 9.21789 0.206273 11.2536 -3.38139 -4.49977 -6.76529 -306 2 9.17946 1.37162 10.1615 -3.40595 -8.11879 6.74876 -307 1 9.15707 15.1255 10.1914 20.6551 -3.22149 9.33909 -308 2 9.01609 15.916 9.68312 -8.41387 13.877 -8.61246 -309 2 8.34011 14.6408 10.1195 -14.233 -7.19689 -0.719266 -310 1 0.808146 9.70808 10.2086 23.84 -38.9856 -20.0319 -311 2 0.930598 10.6496 10.3444 5.65872 6.03362 4.8682 -312 2 1.64643 9.29884 9.83207 -32.5144 23.6532 16.8406 -313 1 17.0698 4.80337 8.05752 27.8638 -35.1931 -3.66362 -314 2 16.2966 5.30586 8.21629 -27.2809 18.9512 9.97555 -315 2 16.9993 3.9693 8.55928 -0.62818 15.8913 -5.61459 -316 1 14.8223 14.6574 0.153467 -11.4546 -14.4551 -9.90243 -317 2 15.436 15.0274 0.766448 14.8773 15.1477 17.5942 -318 2 14.121 14.2916 0.705806 -3.92817 0.026116 -2.07816 -319 1 3.85634 11.0156 9.57857 3.75671 2.20251 0.903354 -320 2 3.89754 11.3203 10.4983 -5.37308 2.01291 2.42961 -321 2 3.35837 11.6719 9.06911 -6.8083 1.73507 0.204751 -322 1 11.3728 10.7464 1.42992 33.2497 -4.81825 9.44885 -323 2 11.5281 11.6383 1.10055 0.915848 5.55374 -4.33141 -324 2 10.4426 10.6155 1.47257 -31.1398 -0.627116 -5.41705 -325 1 13.1828 7.20447 12.6676 -0.0478479 -14.2604 -0.4669 -326 2 14.1298 6.99811 12.5505 -7.76827 -0.67018 4.43892 -327 2 12.735 6.32848 12.7534 7.45412 15.7346 -2.47341 -328 1 9.63194 1.91441 0.890304 3.16134 4.31897 -8.70512 -329 2 8.77158 1.63222 0.526893 10.8452 7.48256 0.350857 -330 2 10.2032 2.19638 0.151243 -8.90992 -2.48069 6.74103 -331 1 10.6318 13.4626 4.55882 -11.5056 -1.99047 12.5083 -332 2 11.4876 13.0509 4.71851 7.47615 -1.29416 -2.63952 -333 2 10.4232 13.8662 5.41293 0.691023 4.41994 -1.81408 -334 1 14.5517 1.66181 10.9802 -11.5576 12.9 9.45395 -335 2 15.3776 1.3055 10.6442 8.04202 2.4344 -3.19562 -336 2 14.6907 2.6148 11.169 4.38713 -8.31284 -15.1855 -337 1 14.4901 12.0498 11.5809 -31.454 -4.77499 25.6083 -338 2 15.091 12.4736 11.0015 28.7023 12.1919 -21.8177 -339 2 13.8321 11.6274 11.0162 -1.74489 3.16984 -4.97875 -340 1 8.17369 5.13537 9.87952 -12.8505 7.96449 12.3464 -341 2 7.30162 5.126 10.3345 14.626 0.500686 -8.94194 -342 2 8.32701 4.24033 9.57061 -3.03583 -8.79147 -1.32617 -343 1 1.61182 16.9829 18.4557 19.3906 15.8485 -25.2691 -344 2 2.09739 17.4464 17.7224 -9.17701 -12.9822 18.3353 -345 2 1.80792 16.0477 18.3234 -0.14796 -4.92565 -1.79656 -346 1 1.43858 17.3769 15.3174 -8.9259 8.94647 7.52005 -347 2 1.45812 18.1702 15.9147 -6.93156 -15.9408 -17.1792 -348 2 0.507347 17.0882 15.1685 14.4449 8.30676 8.33907 -349 1 3.5257 5.78471 6.06613 -3.39677 -13.3058 1.89016 -350 2 2.9753 6.46227 6.46115 -3.38454 1.41808 7.55669 -351 2 4.15739 6.26663 5.53865 9.2569 4.30143 -12.1591 -352 1 12.629 9.51298 14.2604 -9.77978 19.3775 3.35531 -353 2 12.9437 8.76225 13.7938 15.2815 -22.6591 -22.819 -354 2 12.3447 9.10922 15.0729 -6.56341 1.36458 18.6396 -355 1 4.0928 15.2431 7.0497 -2.25109 -22.7738 13.7055 -356 2 3.66448 16.0653 6.81785 -2.80743 13.3283 -7.68 -357 2 5.04695 15.3859 7.01583 3.36741 6.66555 -6.63338 -358 1 0.780201 8.79903 15.0924 -4.1065 -28.223 6.26572 -359 2 0.548696 9.72105 15.1288 -1.34907 18.7642 -4.10325 -360 2 1.5752 8.72345 14.5481 -0.207921 7.22304 -3.82448 -361 1 12.9286 8.29499 10.1476 33.3114 -28.911 32.5654 -362 2 13.7554 7.80683 9.90421 -18.1809 10.2081 -7.43875 -363 2 12.9042 8.10572 11.1188 -9.83308 4.93442 -19.3471 -364 1 15.2998 7.93844 3.50826 -21.0939 -7.00262 -11.8412 -365 2 14.4558 7.58878 3.24395 -11.6977 10.4201 -28.099 -366 2 15.3831 7.3862 4.26257 30.2163 -1.92794 33.2483 -367 1 17.18 6.71526 18.6425 -0.133844 12.8911 -12.7702 -368 2 16.7451 5.93694 0.322596 -6.25651 -15.7248 7.28694 -369 2 16.4413 7.25778 18.3094 9.30548 1.37884 5.01187 -370 1 8.9084 6.99396 7.88573 -0.881002 2.32267 0.0260346 -371 2 9.83584 7.2627 7.79742 -0.0847644 -0.13812 3.11438 -372 2 8.83558 6.46246 8.69404 -0.0294368 0.694249 -1.22754 -373 1 12.437 0.501834 1.22358 -0.716997 -8.58934 -9.29719 -374 2 13.1312 1.05983 1.5788 8.89791 0.478791 5.50433 -375 2 12.732 0.307907 0.326573 -3.73597 1.67796 1.81541 -376 1 5.69458 15.0516 14.5143 3.69591 -14.2553 -4.53333 -377 2 4.76954 15.0969 14.776 -8.31751 1.66253 0.63197 -378 2 5.95328 15.9515 14.3109 5.80865 11.3045 -3.56535 -379 1 3.78081 6.42509 1.75203 4.2348 -8.30075 -4.29513 -380 2 3.33672 7.18396 1.37288 -3.60544 13.0853 -6.67388 -381 2 3.84967 6.63422 2.68491 0.545892 0.795555 6.86444 -382 1 3.88792 11.3989 12.3546 13.0971 -5.24635 -8.64578 -383 2 4.74838 11.8202 12.5261 -6.66532 -1.91753 0.168546 -384 2 3.23677 11.927 12.8169 -5.64663 9.70313 4.55872 -385 1 5.30252 3.85246 15.7701 3.45242 11.6571 4.53522 -386 2 6.06202 3.27771 15.61 2.30678 -4.65184 -5.35711 -387 2 5.68598 4.72788 15.9368 -2.89319 -4.23448 -3.12102 -388 1 14.1378 10.1309 4.62741 -6.40911 2.93718 -21.1253 -389 2 14.285 9.82325 5.50803 7.98673 -9.05047 24.7099 -390 2 14.6717 9.53242 4.07811 -2.84302 6.29722 1.17771 -391 1 7.65634 17.3346 9.10408 10.3132 -24.7491 -1.74792 -392 2 7.07794 17.6856 9.78277 -9.16436 8.21537 0.604828 -393 2 7.96278 18.0151 8.50473 -0.553145 15.1908 -4.94918 -394 1 4.52232 14.5173 3.95827 12.1345 -25.6108 -47.7046 -395 2 4.42958 15.3956 4.25649 -1.76895 36.8878 18.7873 -396 2 4.4098 13.9051 4.66351 -3.8607 -15.3504 25.5968 -397 1 14.1258 7.45828 15.8364 -6.23365 -6.73609 3.75314 -398 2 14.9302 7.39167 15.3277 7.57838 -0.290505 -5.08612 -399 2 14.4287 7.78058 16.69 -2.09073 5.34234 4.78248 -400 1 2.95098 18.3751 1.91859 -29.5535 -1.78839 -16.8987 -401 2 2.45071 17.8858 1.20736 17.1758 4.42604 21.0133 -402 2 2.2449 0.246547 2.36374 11.8246 -5.6794 -7.15496 -403 1 7.99154 1.5773 4.49846 30.6245 -5.45524 3.73918 -404 2 7.42382 1.97686 3.83614 -1.09908 5.00667 -8.45405 -405 2 8.90683 1.55308 4.13454 -22.7919 6.21994 3.05753 -406 1 2.44336 14.1732 17.7263 2.89693 8.8065 2.99283 -407 2 1.80182 13.5359 18.0713 -0.462046 0.279758 -5.24045 -408 2 3.30188 13.814 17.96 10.6791 -8.66055 4.12847 -409 1 0.94217 1.90899 13.8934 13.5408 -1.52741 -1.05885 -410 2 1.19747 1.57322 14.7589 -4.95142 3.16298 5.50662 -411 2 18.6373 2.03702 13.8998 -8.7871 -0.483879 -2.02084 -412 1 4.30938 0.151078 13.8855 7.43827 7.09651 -9.2822 -413 2 5.23906 18.5299 13.9426 -3.76642 -3.92995 -1.86801 -414 2 3.88869 18.4591 14.673 -3.49259 -4.03929 12.0029 -415 1 7.32054 0.93366 18.4163 -33.3446 -10.4004 5.92831 -416 2 7.32153 0.654144 17.4916 5.03052 -1.00997 0.0977128 -417 2 6.36163 0.937686 18.6972 26.0729 9.45288 -6.86634 -418 1 15.8933 18.4156 13.9169 -22.9956 8.12347 -47.8741 -419 2 14.9583 18.5802 13.6337 24.0447 -6.26997 16.1472 -420 2 15.9487 18.2637 14.8423 -3.56821 2.97357 29.888 -421 1 10.2651 4.57121 16.2688 1.93413 -35.0494 -13.7078 -422 2 11.2092 4.46181 16.4883 -7.31309 8.12251 -3.69007 -423 2 10.0229 3.6678 15.9192 2.49448 27.3645 14.4368 -424 1 15.9059 17.707 4.46041 -10.2591 -26.7612 -3.24664 -425 2 16.489 18.4443 4.44561 19.3223 26.1038 4.21423 -426 2 15.1093 18.0276 4.88994 -9.23113 3.77657 -1.20249 -427 1 6.91304 17.5561 13.9404 -32.5423 1.81832 8.8205 -428 2 7.45718 17.7359 14.6891 13.6263 3.56972 27.349 -429 2 7.55119 17.4736 13.2627 22.9256 -5.60471 -32.7019 -430 1 13.1887 6.46821 6.52506 2.14134 -6.99498 -16.9539 -431 2 14.1468 6.55272 6.36688 -10.1834 4.86047 2.66897 -432 2 12.7776 6.33144 5.63446 11.1073 4.86992 20.3892 -433 1 7.86929 2.3014 9.43186 -7.43999 -0.581733 -7.42672 -434 2 7.28758 2.26368 10.206 1.54253 -4.13193 1.23421 -435 2 7.37428 1.85692 8.71867 3.17855 7.90221 2.8646 -436 1 15.2039 14.7441 13.779 -1.62406 2.57688 -1.70285 -437 2 14.9354 14.9492 14.6806 -4.8726 3.09257 3.44485 -438 2 14.7582 15.3762 13.1995 0.661267 -3.02741 1.58802 -439 1 9.4149 8.38535 3.859 -25.1665 -10.991 -5.57318 -440 2 10.2049 8.88585 3.99067 20.2759 12.8236 2.22258 -441 2 9.67249 7.46496 3.96553 -1.56288 -2.67339 -2.00262 -442 1 17.7026 13.5834 16.4242 -1.80346 -11.0476 6.4727 -443 2 16.7549 13.3713 16.3986 -0.662501 7.25922 -2.44544 -444 2 17.8485 14.4294 15.9813 -4.13054 1.45271 -4.35383 -445 1 4.91191 10.5224 2.88074 35.1139 -21.7488 -13.7776 -446 2 5.74832 10.1175 3.20879 -18.1595 7.39309 -6.65206 -447 2 4.64711 11.0636 3.60968 -4.98951 12.9254 11.8317 -448 1 3.70989 8.40692 9.9178 -3.43098 -13.3807 16.77 -449 2 3.72102 9.34916 9.72654 3.49477 5.64054 -2.09668 -450 2 3.74613 8.34545 10.8924 -2.49133 1.09455 -12.0955 -451 1 15.9811 6.93645 5.90716 -9.64967 -5.56515 0.983492 -452 2 16.7246 7.40088 6.29715 7.31355 3.31596 3.21676 -453 2 16.2311 6.00551 5.84179 2.78737 3.87161 -3.53071 -454 1 15.2416 7.2288 8.97537 -25.1477 -13.3308 -14.4253 -455 2 15.9965 7.60799 9.37505 30.1105 10.4166 22.3283 -456 2 15.0439 7.80906 8.23828 -3.19363 1.15625 -6.55237 -457 1 6.20437 12.8345 12.7354 -14.1465 10.1654 -16.7884 -458 2 6.94522 12.3758 13.1101 18.4885 -10.5564 10.7987 -459 2 6.04629 13.6348 13.2503 2.66058 2.52169 8.79246 -460 1 12.1262 4.55048 13.1243 17.0811 13.049 12.1055 -461 2 12.3395 4.65477 14.0809 -9.37635 -6.07885 -14.152 -462 2 11.329 4.03313 13.0256 -8.31182 -5.5816 3.57791 -463 1 11.4354 8.07801 7.94226 -0.810806 3.70784 -8.7596 -464 2 12.2037 7.66847 7.47953 -11.1819 -0.00285319 12.9065 -465 2 11.6202 8.13058 8.89801 9.03316 -1.52538 -12.7532 -466 1 16.9943 10.8342 7.6109 -5.03955 -8.49642 17.9987 -467 2 17.7716 10.3123 7.42961 10.8043 -13.0503 -0.479497 -468 2 16.9113 11.4133 6.86596 -8.14606 13.8231 -19.3584 -469 1 5.21042 18.0585 10.7699 15.6232 7.92267 2.97831 -470 2 4.74775 17.5474 11.4283 -5.6196 -5.04348 5.46467 -471 2 4.57391 18.2408 10.077 -8.01525 -1.2934 -10.8517 -472 1 7.60043 17.4332 1.64042 6.79415 6.05281 -21.827 -473 2 7.93761 16.6332 1.20425 2.91062 0.230192 8.27204 -474 2 7.75711 18.1408 0.980897 -9.32049 -5.6032 10.0359 -475 1 1.93897 12.9382 13.63 3.13689 -3.11692 -16.6768 -476 2 1.43678 12.3217 14.1546 -10.1951 -7.38374 9.42459 -477 2 2.04891 13.7234 14.1672 6.66588 6.79896 5.37665 -478 1 9.3938 6.77683 14.8244 15.3217 -3.43003 -1.39025 -479 2 9.8639 6.00007 15.2423 -8.39432 15.0581 -15.9266 -480 2 9.75443 6.97816 13.9251 -4.83499 -14.7492 16.6004 -481 1 15.2802 4.37234 10.7612 17.1837 -0.598437 7.1821 -482 2 16.2442 4.23454 10.6079 -20.4209 -0.451849 5.19081 -483 2 15.2528 4.98337 11.5249 -0.66536 -5.42981 -12.7574 -484 1 11.4105 6.21551 0.0734026 -8.7314 7.93342 -2.27424 -485 2 11.3895 5.26963 0.0141504 12.2817 -18.3718 -0.889513 -486 2 10.499 6.41528 18.4856 -6.56297 9.87049 -0.998012 -487 1 18.513 11.4235 14.9225 12.9282 -22.681 3.72438 -488 2 17.9895 11.7369 14.1972 -5.90482 9.25399 -19.4183 -489 2 18.3571 12.0937 15.574 -0.537982 14.5307 17.0247 -490 1 7.08328 9.28085 7.30918 -19.7197 4.18214 5.56511 -491 2 6.73297 8.51044 7.78417 1.76821 -0.286333 -7.5509 -492 2 8.01676 9.1548 7.24802 24.3996 -5.081 -1.83944 -493 1 18.3255 15.3437 12.2137 -3.8694 0.735905 0.400418 -494 2 0.599616 15.5 11.9645 6.26195 2.32841 -0.363056 -495 2 17.7995 15.7522 11.5099 -2.40985 0.96637 0.371307 -496 1 16.511 4.37404 5.22763 -21.2214 -5.51878 25.3236 -497 2 16.4647 3.99489 6.12381 2.74309 1.28503 -9.80457 -498 2 17.4303 4.54035 5.0616 22.4703 -0.915278 -13.9933 -499 1 17.7218 3.13981 10.7749 -4.33552 13.9915 6.34554 -500 2 18.6231 3.34836 11.0663 1.21144 -2.68719 -3.11144 -501 2 17.734 2.28626 10.3485 2.99182 -14.4528 -5.38806 -502 1 12.2792 18.655 10.1327 17.2693 -45.8263 -15.1364 -503 2 11.5058 0.449575 10.4425 -26.2107 18.2097 8.79889 -504 2 13.0094 0.611642 10.1232 12.3896 24.8189 4.81349 -505 1 10.4214 9.73086 12.5154 -11.4047 -1.1898 4.78042 -506 2 11.1516 9.87418 13.1364 2.96428 -4.00819 -1.03044 -507 2 10.2474 8.77319 12.4992 9.30457 6.64045 -3.3636 -508 1 0.651598 2.68478 7.18172 -17.9134 21.5061 -11.8097 -509 2 0.347525 3.6016 7.34273 5.69642 -14.867 -2.54197 -510 2 0.849668 2.34638 8.05251 8.91351 -8.30419 8.52406 -511 1 0.318497 15.272 6.90444 -3.43175 -0.902574 -18.2314 -512 2 0.478582 15.5644 7.78858 6.40513 2.68345 23.4663 -513 2 0.623162 14.3599 6.89897 0.272636 -4.92753 -7.69196 -514 1 17.0533 6.94572 15.0273 7.81631 0.565766 -0.894277 -515 2 17.8128 7.55845 14.958 -6.36521 -5.11302 -0.197876 -516 2 17.4132 6.11744 15.3876 -1.58799 4.21551 0.905627 -517 1 9.15046 12.5368 8.00027 -36.358 14.0028 8.44058 -518 2 9.59383 11.9142 7.43445 3.21629 -19.4527 -15.2125 -519 2 8.22229 12.648 7.66907 25.8785 -7.47424 5.38289 -520 1 1.16102 1.67919 2.79298 -14.264 -19.5534 -4.4961 -521 2 1.06769 2.21394 1.99483 -1.93616 3.76767 1.09072 -522 2 1.84572 2.00753 3.35812 13.0572 19.5695 8.60311 -523 1 4.13351 15.1441 9.8761 6.18483 -5.86151 -6.61306 -524 2 3.91524 15.1965 8.93344 2.62784 3.42174 0.908977 -525 2 5.03514 14.7702 9.87632 -7.63961 1.62567 3.94135 -526 1 7.3909 2.2738 14.7748 9.28558 9.05007 -9.33433 -527 2 7.12441 1.5503 14.2057 -1.53405 -3.63662 -1.19206 -528 2 7.87829 2.88836 14.1809 -18.0097 -8.54319 17.0088 -529 1 18.3492 14.5565 2.15246 12.0934 24.362 7.12212 -530 2 0.551729 14.8667 2.53499 -6.69921 -6.84856 -6.85574 -531 2 17.7888 15.364 2.12839 1.3753 -15.6354 -3.85708 -532 1 10.0163 2.6808 12.9164 -0.493731 -5.11601 -9.40492 -533 2 9.92018 2.0572 12.1601 0.76191 10.4011 8.73608 -534 2 9.26265 3.29452 12.869 4.65507 -2.10266 -3.09911 -535 1 2.95427 8.9021 13.1034 24.5728 -3.04867 -5.91166 -536 2 3.51177 9.68096 12.817 -20.8286 -16.9148 9.19061 -537 2 3.59809 8.18481 13.2917 -7.73525 14.463 -2.49767 -538 1 3.26448 8.6069 3.78485 -10.2248 -21.121 34.5648 -539 2 3.76672 9.19042 3.24166 13.0731 20.305 -12.8555 -540 2 3.48359 8.83627 4.72374 -5.93153 -5.30867 -25.3462 -541 1 5.8473 7.24819 8.6208 2.3932 7.90906 9.86277 -542 2 5.81432 6.28497 8.53212 -5.5277 -2.57364 -0.635967 -543 2 5.0659 7.54439 9.12071 1.08185 -7.49096 -4.29671 -544 1 14.8764 1.57981 1.83846 12.2497 10.4795 -14.7641 -545 2 15.1104 2.2908 2.43504 -9.02026 1.90223 13.0204 -546 2 15.3525 1.8445 1.03212 -8.04537 -15.132 5.23431 -547 1 8.61698 15.0264 0.696156 7.89205 -2.64916 2.43147 -548 2 9.41092 14.8348 1.25307 -18.4618 8.30064 -5.38467 -549 2 7.89576 14.464 1.0316 3.03152 0.23278 2.41128 -550 1 15.4513 1.4301 7.20503 6.99627 -6.82188 0.69389 -551 2 14.8244 0.90582 6.69357 -2.8394 0.789398 0.0418873 -552 2 15.0149 2.26607 7.38205 -7.95005 6.31947 4.24803 -553 1 4.96675 12.927 18.445 -0.392058 -1.0762 11.0005 -554 2 5.34886 12.9244 0.695922 -4.30965 1.19363 -4.30526 -555 2 5.68 13.266 17.9034 2.74534 3.65082 -4.88489 -556 1 15.3953 8.66034 18.0902 -2.07624 -16.7815 -3.18775 -557 2 15.9144 9.19311 17.4724 -5.66293 4.97787 2.21077 -558 2 15.1583 9.22886 0.188985 2.48846 7.45062 3.31632 -559 1 12.0359 3.11648 18.28 -8.04977 7.84102 -5.19135 -560 2 12.2901 3.11968 0.565205 5.43673 -10.4163 -2.44039 -561 2 12.4787 2.41139 17.7764 2.20222 0.638625 8.9068 -562 1 13.1884 12.6911 5.14611 -2.25763 -6.31837 -0.123489 -563 2 13.4652 11.7849 4.90596 3.78769 10.9202 3.38983 -564 2 13.3386 12.7839 6.10454 1.74722 -2.69816 -5.37077 -565 1 6.12211 7.19464 0.152335 -0.889801 -16.5081 12.3486 -566 2 6.2475 8.12337 19.0248 -9.08967 1.02729 -5.81202 -567 2 5.35557 6.85974 0.666933 3.80599 9.00251 -10.0268 -568 1 17.6814 15.8746 14.896 -32.95 0.345881 -9.96463 -569 2 16.7135 15.9334 14.9982 15.4899 6.1636 11.5551 -570 2 17.7111 15.6936 13.9484 19.9419 -0.275145 -3.25111 -571 1 13.1284 0.88699 16.7751 -4.95458 6.20661 5.10718 -572 2 14.0638 0.660956 16.7688 7.30918 -0.228866 0.981928 -573 2 12.6898 18.6827 16.6682 -2.70263 -7.7996 -4.366 -574 1 10.8711 14.4993 7.46323 15.7126 -17.3597 -1.2585 -575 2 10.128 14.0173 7.85917 4.58757 6.56369 -3.56814 -576 2 11.6082 13.8461 7.48059 -10.4237 16.2655 0.791757 -577 1 17.6751 8.40087 2.13849 -13.7675 10.6042 3.42109 -578 2 16.7708 8.37025 2.51335 11.2555 0.423493 -3.0905 -579 2 17.6147 7.881 1.33167 1.95975 -7.58305 -2.5048 -580 1 12.424 7.82566 2.03348 6.80204 18.2298 -3.36389 -581 2 12.2928 8.74872 1.74157 -3.31877 -9.32949 5.70746 -582 2 11.9673 7.27395 1.39444 0.405274 -3.29714 -11.9602 -583 1 12.0088 14.6056 10.3972 49.4943 -15.6831 -19.0447 -584 2 12.4654 14.316 9.56616 -19.1829 7.51475 23.0356 -585 2 11.0956 14.6861 10.1978 -35.275 4.57666 -6.07844 -586 1 6.81054 6.90501 15.534 -24.6279 -1.31201 9.93627 -587 2 7.70831 7.14913 15.3109 11.0416 1.99651 0.427612 -588 2 6.48555 7.50951 16.2192 7.91049 -4.43387 -1.91407 -589 1 7.94039 4.47545 13.2332 14.4982 34.8647 21.806 -590 2 7.26408 4.6474 12.5684 -6.44209 3.92223 0.968251 -591 2 8.05746 5.34482 13.7439 -3.25809 -36.365 -21.9094 -592 1 13.3499 12.2014 14.3127 -1.24116 1.37617 13.1465 -593 2 13.3241 11.2332 14.3368 -6.04942 0.470969 -4.28371 -594 2 13.6308 12.4336 13.4212 3.90264 0.498209 -3.09495 -595 1 14.5954 9.45997 7.28998 13.2192 -1.86441 -1.0042 -596 2 15.4197 9.90762 7.5754 -11.2574 0.0534663 -4.99205 -597 2 13.8535 9.8793 7.72336 -3.17401 5.05716 8.17378 -598 1 12.6619 16.8656 3.26711 -0.0867316 -13.7478 -1.21165 -599 2 12.9036 17.3981 4.01825 1.80146 10.547 8.89773 -600 2 12.7645 17.4143 2.493 -0.0316456 12.4477 -7.66427 -601 1 1.00141 7.10091 17.3455 15.3286 -2.27437 -0.63111 -602 2 0.197357 6.73674 17.6796 -23.7065 -4.2556 16.6559 -603 2 0.696205 7.72166 16.6912 7.12828 11.4292 -16.7267 -604 1 12.984 4.84784 15.752 -30.1278 -7.6986 -1.85236 -605 2 13.773 4.32613 15.627 12.1969 -0.534485 4.03194 -606 2 13.2127 5.76882 15.785 16.3015 19.3583 1.60965 -607 1 2.35806 3.40155 5.13736 7.00458 -19.3644 -43.6846 -608 2 1.86996 2.9687 5.81855 -13.4119 -5.52905 24.958 -609 2 2.73401 4.18924 5.49805 8.9837 23.3098 13.0491 -610 1 8.19273 10.9521 13.6844 -8.81681 4.64201 23.2716 -611 2 8.19092 10.7627 14.6526 -0.424045 0.881441 -21.4162 -612 2 8.95149 10.4932 13.3231 15.2004 -1.23984 -4.72202 -613 1 13.0449 1.52469 13.2577 -17.2068 8.30684 11.3152 -614 2 13.5293 1.59874 12.4201 -3.55841 -0.219514 3.90721 -615 2 12.4208 2.28784 13.3343 18.9425 -17.4385 -9.09999 -616 1 6.61166 13.6023 2.12464 -9.14589 11.0627 -26.7302 -617 2 6.03511 14.0379 2.75872 -4.67031 1.02227 7.02539 -618 2 7.1693 13.0213 2.62577 8.97168 -8.12604 14.3361 -619 1 15.8326 6.37868 12.5447 13.0084 18.5244 20.7727 -620 2 16.3675 6.96965 11.9727 -5.6566 -10.5049 5.53461 -621 2 16.1589 6.56267 13.4684 -3.25982 -7.33208 -24.589 -622 1 16.7829 0.679169 9.53725 3.65315 -1.00951 10.2573 -623 2 16.653 18.4141 9.83094 1.34292 -7.75704 2.15353 -624 2 16.269 0.772043 8.73148 -3.87084 4.41009 -12.8197 -625 1 6.12871 11.643 8.2509 28.8456 37.0564 -10.7514 -626 2 5.32101 11.4251 8.67159 -25.2961 -16.2243 16.4685 -627 2 6.59615 10.8374 8.068 1.48557 -20.4229 -4.39625 -628 1 2.81588 8.6455 0.385911 -12.1168 -14.4708 -15.8933 -629 2 2.2408 8.27575 18.315 12.5525 5.70225 18.3425 -630 2 2.25296 9.2478 0.88122 -2.81952 5.7616 1.15354 -631 1 10.1112 10.3249 6.56463 -6.88185 10.2676 4.3595 -632 2 10.6724 9.72741 7.0699 2.3169 -7.24343 0.885556 -633 2 10.4905 10.3984 5.68005 1.7842 -2.70629 0.197339 -634 1 6.85117 15.7741 6.71172 -4.51814 -4.38518 8.0947 -635 2 7.10947 16.276 7.50071 -0.280141 -2.70051 -1.05147 -636 2 7.0022 16.3747 5.97143 2.95927 2.8361 -5.64101 -637 1 6.55245 12.8624 5.85582 3.66478 4.31955 2.99752 -638 2 6.71899 13.7301 6.24424 -0.933807 5.79026 -3.46681 -639 2 6.12481 12.3549 6.55179 0.263982 -0.200358 2.15574 -640 1 16.7435 12.5401 9.7846 -13.9618 -8.21713 16.7649 -641 2 16.8388 11.8663 9.10427 2.99064 0.578166 -4.74348 -642 2 17.1608 13.3339 9.48085 7.01955 11.3182 -8.14386 -643 1 6.27773 2.82725 2.7475 -16.1332 4.52919 -16.5002 -644 2 6.37029 3.76301 2.48637 6.52487 -6.75351 6.59876 -645 2 5.7241 2.45518 2.0296 8.37538 -0.331655 9.00677 -646 1 10.7419 2.97566 3.2545 -3.93098 2.36946 -8.35386 -647 2 10.3631 3.83794 3.45313 -5.44824 -1.84651 0.91029 -648 2 10.2755 2.65841 2.45654 4.06882 -1.04864 5.83378 -ITEM: TIMESTEP -90 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.80968 6.6261 17.8375 -14.5778 0.995444 8.41947 -2 2 7.95772 6.60642 18.3334 15.3437 1.8775 -14.2431 -3 2 8.74654 5.99095 17.1112 1.57504 -1.57025 6.7209 -4 1 0.142832 8.36014 6.73441 10.0116 -15.4349 27.0014 -5 2 0.232649 8.20449 5.79462 4.11725 -7.32768 -11.6468 -6 2 0.67494 7.65251 7.20998 -18.6261 25.5606 -16.1468 -7 1 8.65703 0.380136 6.98192 16.3005 -1.0776 2.50655 -8 2 9.57515 0.309779 6.66722 -10.0942 0.994659 4.05519 -9 2 8.27212 1.03395 6.395 -6.58679 0.322126 -3.42087 -10 1 6.47941 1.69165 11.7468 2.00503 -21.4393 -6.03474 -11 2 5.9725 2.29393 12.2744 -13.1143 10.2157 7.12378 -12 2 5.89376 0.920881 11.5936 7.71629 6.15291 -2.33076 -13 1 6.9103 5.50063 2.38437 -35.7814 23.4203 2.69428 -14 2 6.20944 5.92743 2.96221 29.3961 -15.7919 -7.47581 -15 2 6.73166 5.94071 1.53167 10.6635 -7.16691 8.95661 -16 1 16.211 10.2361 16.1124 -22.7966 -2.93172 13.0323 -17 2 16.937 10.2632 15.5246 28.6916 5.0146 -15.8412 -18 2 15.9737 11.152 16.3021 -3.36115 -0.429235 -4.16748 -19 1 10.8196 14.9788 2.33309 -6.31813 -9.42536 4.48609 -20 2 10.7437 14.525 3.19227 -2.25161 -0.175376 -6.3843 -21 2 11.168 15.8375 2.56675 6.6431 8.63317 3.56201 -22 1 17.1655 8.21466 10.9616 20.3007 -11.9207 -19.649 -23 2 16.6876 8.89778 11.4174 -14.8371 14.2918 8.905 -24 2 17.9353 8.67496 10.5709 -5.82559 -3.7293 4.59063 -25 1 14.5981 15.9748 16.3536 13.4587 -18.0704 19.8012 -26 2 13.6875 16.2688 16.3636 -10.2246 8.72504 -7.33216 -27 2 14.6733 15.4751 17.2031 2.63957 5.2712 -15.5493 -28 1 12.1292 13.2811 0.580093 14.6523 -12.0599 13.1814 -29 2 11.875 13.3883 18.3092 -10.372 6.98394 -12.7652 -30 2 11.639 13.8901 1.1449 -2.74566 6.59249 -3.74219 -31 1 9.34925 5.48981 3.82539 12.3818 -0.191077 28.8485 -32 2 8.80634 5.44704 4.61652 7.17551 -1.92534 15.5524 -33 2 8.65833 5.42982 3.20736 -26.4153 -0.989629 -43.3837 -34 1 1.57757 3.9189 11.5719 -21.368 33.8782 -18.8992 -35 2 1.50486 4.82423 11.9434 2.77 -7.29772 -4.79385 -36 2 1.95891 3.38097 12.2317 20.2106 -22.0339 29.781 -37 1 2.11583 6.92705 8.12278 -10.2704 -2.23476 -15.4196 -38 2 2.47676 7.42607 8.85663 6.65774 -1.70501 8.2798 -39 2 2.06913 5.99576 8.38149 2.03129 -2.32531 8.57063 -40 1 5.2846 4.43559 7.83749 -11.1092 26.0267 -7.92074 -41 2 5.42959 3.50305 7.74019 3.58921 -20.4287 3.63869 -42 2 4.59753 4.67739 7.1831 9.16507 -0.464339 6.41033 -43 1 3.36483 2.87842 17.4354 -5.48754 -0.0293267 11.8999 -44 2 4.0122 3.13798 16.7945 16.5223 13.9802 -16.1706 -45 2 2.91387 3.69111 17.7275 -1.08839 -5.27878 2.29607 -46 1 7.51128 5.54904 6.16479 9.71808 2.6671 3.00483 -47 2 8.12131 6.08033 6.71556 -9.69992 -1.44216 -4.10694 -48 2 7.04033 4.98631 6.78947 -1.48399 -2.17988 -0.0590646 -49 1 9.79239 7.0023 12.0333 -12.7203 -1.67256 -9.54047 -50 2 10.0574 6.1295 11.7028 -2.54946 7.94968 0.438659 -51 2 9.0334 7.28866 11.4661 15.1177 -5.87574 8.09476 -52 1 14.1269 3.84395 8.13857 -24.8841 12.3935 -19.8999 -53 2 13.4363 4.47719 7.80064 24.2741 -16.3277 6.83338 -54 2 14.3749 4.15432 9.00462 4.04893 6.4318 14.0535 -55 1 4.52686 17.2232 3.85531 -7.09571 -9.71268 16.0786 -56 2 5.35353 17.6803 4.02689 3.89364 6.28665 -2.88462 -57 2 3.96567 17.7155 3.24673 4.45666 4.6431 -9.26961 -58 1 16.1958 16.5107 10.5377 18.4287 -13.9772 -31.1199 -59 2 15.4454 16.6557 11.0933 -16.6117 1.05393 13.9092 -60 2 15.8645 15.9242 9.81336 4.55855 15.7974 16.2758 -61 1 1.967 4.85121 0.0645769 9.40837 -19.0171 0.778776 -62 2 2.73793 5.10942 0.56616 3.15966 4.76786 17.0447 -63 2 1.80075 5.61055 18.1709 -12.801 18.3624 -15.2179 -64 1 11.1737 13.314 16.4367 2.74473 1.78814 5.72217 -65 2 10.7128 12.4641 16.5748 8.32361 2.87799 -7.58216 -66 2 11.8417 13.1969 15.7431 -5.18043 -7.14508 -0.417807 -67 1 10.0458 10.8999 16.8205 33.4394 -5.51473 9.19041 -68 2 10.5428 10.0531 16.9406 -15.1708 22.1127 -3.77119 -69 2 9.12902 10.6892 16.7607 -22.7906 -6.8787 -3.44008 -70 1 11.889 17.5084 13.4814 3.48745 6.24304 -13.0003 -71 2 12.5913 17.1622 12.8998 -9.91022 -4.16273 6.93206 -72 2 12.0139 18.4633 13.4204 2.43964 2.21886 2.73389 -73 1 6.44228 9.49569 12.2996 9.71147 -12.8692 -34.1322 -74 2 7.06965 9.17025 11.5988 -17.7592 6.4035 17.1392 -75 2 6.97144 10.0526 12.8659 4.91959 6.23922 4.73193 -76 1 16.3022 12.832 2.75135 -12.5209 9.65366 -4.24277 -77 2 17.1598 13.1655 2.44684 -4.70434 0.462679 5.46936 -78 2 15.6996 13.6248 2.74248 12.9928 -20.5688 3.1232 -79 1 0.706696 12.7395 5.83755 -10.6776 2.47735 15.1944 -80 2 1.02688 12.9731 4.95908 -4.07327 -10.4263 -9.29508 -81 2 18.3891 12.5308 5.80039 14.5368 6.4085 -10.1514 -82 1 5.29875 16.3254 18.4501 12.7507 -5.44046 -6.67673 -83 2 5.72604 15.6129 17.9385 -8.69196 7.59677 5.8406 -84 2 6.01274 16.6418 0.375909 -8.3334 1.51688 4.30584 -85 1 0.743878 7.68205 4.10167 -26.7478 -30.2572 33.4946 -86 2 0.179417 7.92019 3.37827 -7.5716 9.21403 -16.4097 -87 2 1.60385 7.98113 3.89879 36.269 17.899 -12.2731 -88 1 3.22103 9.09598 6.53924 -28.7289 15.6764 -27.4701 -89 2 3.63534 8.61301 7.2251 9.03881 -15.9481 23.3571 -90 2 2.25678 8.88215 6.53178 21.3431 5.76786 5.41461 -91 1 7.2773 10.3926 16.241 -1.60955 -9.9776 11.4431 -92 2 6.63502 11.108 16.2935 -0.090439 -0.440245 3.15105 -93 2 7.09074 9.80627 16.9963 -3.87073 10.8392 -3.46734 -94 1 11.0095 0.891279 5.03438 2.23591 -17.8064 16.3849 -95 2 10.8775 1.7336 4.57918 5.69275 -3.07397 -7.72854 -96 2 10.7003 0.188666 4.43596 -0.931337 13.9517 -3.17827 -97 1 4.21583 2.94335 13.1635 9.62289 2.41259 16.4284 -98 2 4.47922 3.3428 14.0131 -5.18172 -0.255184 -10.0037 -99 2 4.1364 2.00091 13.3783 -2.2119 -1.88246 -4.82143 -100 1 8.45625 10.2801 1.81127 9.01648 -22.0588 9.24648 -101 2 8.30671 10.8697 2.54783 -2.77767 16.2884 7.52121 -102 2 8.66335 9.4444 2.27657 -0.852681 8.00384 -10.6723 -103 1 10.2261 1.659 15.4538 -6.06042 8.31352 -11.6288 -104 2 11.1361 1.48308 15.6359 20.1952 -3.56794 7.64131 -105 2 10.2187 1.98601 14.5369 -5.79366 -2.30068 5.3707 -106 1 2.60435 12.742 7.94637 -6.15341 0.568057 0.983218 -107 2 3.03975 13.5699 7.72118 6.64853 3.0435 -2.79803 -108 2 1.95513 12.6117 7.24141 1.86204 -3.09485 1.26562 -109 1 3.88579 11.7956 5.01149 -19.6155 -13.0634 1.96641 -110 2 3.74363 11.1082 5.69355 0.727972 11.568 -8.07528 -111 2 3.05901 11.8342 4.47209 17.5209 1.69759 11.0979 -112 1 6.76239 14.55 16.9383 -0.403452 -2.75277 4.08609 -113 2 7.61561 14.9826 17.0312 2.52456 -1.29817 -0.221044 -114 2 6.44911 14.7692 16.0549 2.09428 -3.60588 -3.74869 -115 1 14.1942 14.5231 3.16652 -5.12336 -14.4242 4.12891 -116 2 13.6899 15.3256 3.31261 0.149267 9.23779 -5.23449 -117 2 13.7696 13.8761 3.7521 4.09464 2.97302 0.255936 -118 1 8.7401 18.0877 16.1157 -15.0544 -15.1521 5.72203 -119 2 9.42706 17.4939 16.3945 -6.08837 -23.732 7.70311 -120 2 9.27218 0.11536 15.7481 8.35971 40.209 -14.9349 -121 1 4.63391 1.71898 4.89 36.0507 -5.82478 -13.0459 -122 2 3.81997 2.19927 4.85319 -16.3674 13.8452 0.00946397 -123 2 5.20292 2.04685 4.14723 -16.8402 -3.94878 19.5369 -124 1 15.0105 12.65 16.5031 22.0082 2.89039 39.0948 -125 2 14.6032 12.5883 17.4132 0.919275 4.87615 -33.2046 -126 2 14.3966 12.5461 15.7793 -22.8851 -3.84554 -8.75239 -127 1 15.7197 18.424 16.8504 13.0838 27.0964 8.25258 -128 2 16.3964 18.519 17.5419 -1.36847 2.51381 -4.544 -129 2 15.6686 17.4972 16.714 -13.5977 -31.6712 -2.03374 -130 1 1.39308 1.32386 16.6798 -9.07755 4.26299 3.83254 -131 2 2.19455 1.8573 16.8358 -13.1892 -10.0845 0.867767 -132 2 0.760663 1.62622 17.366 11.6728 -4.82483 -8.86289 -133 1 18.2416 4.3099 15.966 -4.36834 -5.16176 -14.6355 -134 2 17.7783 3.61219 15.465 8.57404 10.6893 6.25867 -135 2 0.425079 4.50442 15.5034 -5.04787 -4.14191 4.79432 -136 1 12.0688 17.0582 16.1192 -6.60497 -5.44285 54.7429 -137 2 11.374 16.6436 16.7154 18.2098 8.22439 -32.524 -138 2 11.7541 17.1189 15.223 -7.97888 -4.44492 -17.7493 -139 1 16.0987 2.72798 18.2222 -6.94033 2.52412 -3.34156 -140 2 15.6657 3.49187 18.6187 5.88163 2.98889 4.51464 -141 2 15.8079 2.8031 17.3159 -2.77048 -8.0731 -14.4365 -142 1 6.58612 13.762 10.0351 1.63352 -0.32404 13.73 -143 2 6.39624 13.3299 10.8846 2.34483 4.77487 -0.634471 -144 2 6.55421 13.0562 9.39028 1.369 -6.64332 -8.7831 -145 1 10.1169 18.5721 2.70869 27.9004 -1.02691 -4.20355 -146 2 10.7561 0.140951 1.98734 -15.1054 -0.137902 13.7961 -147 2 9.28626 18.3596 2.30468 -14.2521 -4.05351 -7.65243 -148 1 3.07988 17.6804 6.1902 -35.1734 2.13391 -17.3705 -149 2 2.15682 17.7525 5.8242 24.0448 -4.32039 20.662 -150 2 3.55195 17.7661 5.36197 20.4585 -2.58277 -0.69289 -151 1 12.6061 16.7775 7.89366 1.16584 -8.73771 -17.6522 -152 2 11.856 16.1922 7.7211 -0.763759 -4.24653 -1.89641 -153 2 12.3057 17.3353 8.59898 -2.13454 17.8975 18.5826 -154 1 14.8965 15.3132 8.35277 -22.4274 15.9599 0.214205 -155 2 14.2421 15.9941 8.02515 16.4945 -20.4059 13.6979 -156 2 15.4898 15.1572 7.61828 5.37632 7.31151 -11.1374 -157 1 17.8957 18.2766 0.201476 9.69326 -17.5267 -0.973127 -158 2 18.6995 17.7195 18.781 -12.0492 3.04369 -7.3597 -159 2 18.2321 0.401263 0.645934 -1.5685 17.2308 6.22008 -160 1 0.802158 10.4818 1.45184 -19.0828 -29.4994 30.4216 -161 2 -0.0309651 10.0246 1.77565 29.2477 9.1244 -14.7118 -162 2 0.53478 11.1455 0.834437 -7.87366 18.9841 -18.3051 -163 1 1.85308 12.2863 3.27351 -7.97315 5.10175 -10.2215 -164 2 1.42551 11.5849 2.74616 7.16023 4.54594 2.45335 -165 2 2.09673 12.9814 2.63054 -3.38314 -5.43944 9.55244 -166 1 0.718881 17.2977 4.9616 -19.2906 6.0419 1.76293 -167 2 -0.10575 17.7685 5.12875 8.39755 13.2462 -10.2288 -168 2 0.622971 16.5645 5.55208 6.7728 -21.2776 10.1703 -169 1 1.03867 0.919889 9.35844 3.74022 -6.32288 33.4729 -170 2 1.10918 0.592533 10.3007 6.31379 11.0803 -22.721 -171 2 0.269914 0.464458 9.03134 -8.6906 -2.38217 -7.04515 -172 1 16.7862 2.42581 13.3986 14.7457 27.0937 -15.311 -173 2 16.9847 2.74906 12.4891 -5.29709 -2.40963 18.2684 -174 2 16.5429 1.52129 13.2791 -8.06021 -27.7395 3.47759 -175 1 2.69738 16.0066 12.0777 13.1506 -14.7233 12.6976 -176 2 3.02715 15.5922 12.9029 -9.51867 9.47826 -13.4594 -177 2 3.28974 15.6737 11.3809 -2.31502 2.53439 -1.78657 -178 1 16.3754 15.4917 6.11201 -7.25585 -20.1131 3.67265 -179 2 17.3156 15.5044 6.29369 9.86882 2.22778 5.36532 -180 2 16.2073 16.2228 5.51797 -0.959992 10.1027 -9.31738 -181 1 5.7174 5.24337 11.7813 4.42707 -14.1004 -1.48072 -182 2 5.44277 5.99707 12.328 1.64183 -4.11158 -2.88134 -183 2 5.22325 4.47043 12.1002 -4.92771 7.03451 -4.06757 -184 1 15.1242 4.92712 0.766674 18.5408 -12.9138 10.3204 -185 2 14.9855 4.62556 1.67944 -3.08744 4.9541 4.0864 -186 2 14.3291 5.35182 0.492873 -21.4444 10.4963 -5.72763 -187 1 16.3798 16.4926 1.83048 25.9496 20.3657 -34.7081 -188 2 16.3432 16.8093 2.72897 -9.33108 7.61853 14.7037 -189 2 16.7914 17.2408 1.28765 -16.0156 -28.1785 20.3541 -190 1 0.157471 4.87182 3.99278 -9.81132 22.7056 -3.03191 -191 2 0.5332 5.76253 4.03054 -8.2904 5.08609 0.673103 -192 2 0.911036 4.31937 4.01308 22.6258 -22.4944 4.73784 -193 1 2.97603 15.0857 15.1688 -3.76699 16.0764 -9.28303 -194 2 2.87698 14.8354 16.0845 -1.20729 -14.2266 12.1787 -195 2 2.48786 15.9266 15.1702 1.40562 1.39337 -6.33902 -196 1 1.10637 14.6846 9.51596 31.8836 22.2572 14.4694 -197 2 2.01065 14.9183 9.89233 -34.4229 -12.9306 -18.6629 -198 2 1.03031 13.7317 9.56194 1.94445 -7.79278 4.16037 -199 1 13.55 16.5172 11.5597 10.1041 14.0808 -3.72584 -200 2 13.3442 17.2549 10.9555 -5.19335 -6.01443 7.16005 -201 2 13.1025 15.7566 11.183 -9.96101 -8.306 -1.961 -202 1 4.75563 1.55237 0.702796 10.3802 -26.0161 11.0265 -203 2 4.32304 2.05314 0.014379 -14.7339 5.42124 -2.63334 -204 2 4.14265 0.839056 1.00315 4.15161 14.819 -1.07901 -205 1 1.52656 18.6416 11.9009 -8.95117 16.8483 13.4998 -206 2 1.43825 0.48402 12.7573 3.56637 -8.71242 -18.201 -207 2 1.98334 17.8196 12.0914 3.68072 -6.34965 2.55122 -208 1 11.4393 10.1383 4.17836 -13.7636 4.05009 -8.78245 -209 2 11.3903 10.5027 3.28707 -1.50281 2.58284 -2.63304 -210 2 12.3655 9.96172 4.28712 17.4192 -2.53267 8.67839 -211 1 8.18359 12.1636 3.86104 -21.222 -14.272 -14.5003 -212 2 9.05859 12.5239 4.0446 -0.40723 6.23371 14.3883 -213 2 7.56046 12.2135 4.62832 23.1203 4.46306 -6.77507 -214 1 14.593 4.04535 3.38111 7.28555 -5.40785 -19.1504 -215 2 15.2127 4.15408 4.10794 5.52844 2.67895 3.03112 -216 2 13.7536 4.35259 3.70606 -13.9578 6.65801 6.31365 -217 1 5.72323 1.65443 7.61073 34.4 15.7962 37.2038 -218 2 5.13785 1.03104 8.01585 -19.7408 -11.9782 7.15973 -219 2 5.42676 1.78462 6.74294 -17.7695 -4.7826 -52.6001 -220 1 17.8873 1.06414 4.83181 6.8154 -0.232455 -4.71432 -221 2 18.4369 1.21178 4.04718 -2.79964 -1.76243 2.38037 -222 2 18.3376 1.55744 5.53048 -5.83965 -0.882229 4.9581 -223 1 6.85055 9.23648 4.54341 6.32277 -8.10519 -4.82585 -224 2 6.75809 9.38079 5.49182 3.88959 4.29486 1.07151 -225 2 7.79379 9.02149 4.39148 -10.7358 1.98669 4.12637 -226 1 2.55801 14.782 2.06648 -8.35029 -12.2797 -25.7867 -227 2 3.24533 14.7191 2.71695 15.3489 0.778658 13.055 -228 2 2.98421 14.5338 1.22242 -9.03529 10.4097 12.3511 -229 1 17.2667 12.9721 13.1114 -20.9369 36.2303 -2.57416 -230 2 16.4188 13.4451 13.3365 18.5804 -22.1292 -0.415694 -231 2 17.7749 13.7311 12.7641 -0.529191 -13.9074 0.965338 -232 1 14.8416 10.5583 1.56689 -2.78575 22.6182 14.2458 -233 2 15.4799 11.2066 1.96334 -16.8252 -10.4846 -9.71145 -234 2 13.9405 10.9259 1.71943 20.5685 -8.6057 -5.43477 -235 1 5.6352 6.7176 4.51351 -9.14706 -11.8638 3.15016 -236 2 6.0003 7.60062 4.53525 2.53301 15.852 -6.04122 -237 2 6.16933 6.24394 5.16122 6.25334 -1.18144 -1.3834 -238 1 8.0084 8.26626 10.2701 -4.49752 14.9075 -15.7864 -239 2 8.53054 8.9292 9.77232 -0.437986 -11.1673 11.0277 -240 2 7.35426 7.95022 9.61336 5.97292 -3.64509 13.4454 -241 1 13.4616 18.4657 5.71166 17.1322 -6.35165 -5.45305 -242 2 12.613 0.202175 5.51075 -18.0122 19.0124 -5.00284 -243 2 13.2587 17.813 6.37409 -3.85709 -10.1746 14.3256 -244 1 0.0252945 2.56986 0.408061 0.439602 -5.22175 -5.84652 -245 2 17.7844 2.56336 0.0359587 -11.4993 -5.28871 3.98864 -246 2 0.277142 3.47535 0.26454 16.627 13.7372 -0.461998 -247 1 12.8639 10.8267 9.72576 -55.6075 31.3565 -11.278 -248 2 11.8723 10.9451 9.72713 30.8534 7.0313 -2.47663 -249 2 12.8724 9.89108 9.83244 20.4971 -22.7651 5.79467 -250 1 0.607625 12.2828 11.1117 24.514 -2.72666 -9.78403 -251 2 18.2964 12.3126 11.1603 -11.5713 5.22338 7.13378 -252 2 1.01642 12.6716 11.9034 -8.98148 -2.79725 -0.830812 -253 1 5.29539 7.3549 13.3064 -7.85772 10.5518 3.63543 -254 2 5.70599 8.16396 12.9287 -0.549664 -12.4206 10.9242 -255 2 5.67568 7.22584 14.1948 2.69835 3.31529 -9.72444 -256 1 1.17555 6.77844 11.9244 -33.9372 -12.3631 -14.3141 -257 2 0.259637 6.99751 11.6106 25.929 -3.06653 9.08527 -258 2 1.58097 7.60434 12.1643 7.59492 14.5493 8.35248 -259 1 15.5141 9.76806 12.4302 -1.8656 17.4266 8.04916 -260 2 15.0855 10.6363 12.2204 12.2826 -22.7347 2.36453 -261 2 16.0019 9.91808 13.2494 -6.58523 -0.731675 -3.13373 -262 1 16.4968 12.5534 5.50851 9.37615 -29.7593 -4.66799 -263 2 16.3074 13.4744 5.68685 -5.44524 15.7433 -9.11055 -264 2 16.3732 12.3531 4.54775 0.322938 17.9758 14.7603 -265 1 6.32376 9.8903 0.169934 -28.7401 -0.365509 -5.18995 -266 2 5.50824 10.2805 0.557378 14.6251 -5.00462 -6.15541 -267 2 7.04833 10.2225 0.694867 12.727 0.898893 11.9262 -268 1 12.1515 6.04661 4.01259 -24.0177 -36.8905 11.864 -269 2 12.231 6.67099 3.30768 1.42994 18.9462 -13.2923 -270 2 11.2548 5.64061 3.89367 21.868 15.3866 4.7403 -271 1 0.316109 12.8908 0.0158726 1.97018 -1.90411 4.82087 -272 2 18.784 13.4984 0.752127 -2.36898 -0.989285 -3.79 -273 2 18.4247 13.2164 17.9164 2.23727 -3.47257 5.47524 -274 1 3.55093 0.0615484 8.6771 30.4928 -5.90286 -4.02028 -275 2 3.49841 18.2151 7.84215 -7.8476 4.22576 -1.41638 -276 2 2.7473 0.557235 8.76228 -21.0031 4.54937 0.225707 -277 1 7.3901 17.5352 4.48573 6.23592 32.7201 -14.6481 -278 2 7.69571 18.4853 4.57976 -11.8279 -33.7706 3.32686 -279 2 7.33788 17.4402 3.51852 2.74261 -6.71083 9.2357 -280 1 9.25 17.16 12.2333 -3.7288 14.5824 3.61249 -281 2 9.26512 16.5009 11.5521 -3.80961 -18.6559 -12.0666 -282 2 10.1634 17.2094 12.5273 3.6148 1.53928 10.2644 -283 1 13.402 13.1082 7.90091 0.220655 -14.9059 29.302 -284 2 13.4302 12.436 8.64233 -5.21958 14.4877 -25.9571 -285 2 13.929 13.8525 8.23076 3.39805 -3.2421 -4.10773 -286 1 14.8025 2.90677 15.4495 23.2091 4.40575 2.70159 -287 2 14.1483 2.29946 15.1328 -14.8482 -16.0174 -4.02081 -288 2 15.4935 2.87296 14.7763 0.208871 3.12507 -3.30872 -289 1 9.90762 15.6519 16.9195 -4.56731 4.54647 -2.1455 -290 2 10.1638 14.7845 16.5964 9.48907 -4.21512 -5.5698 -291 2 9.51082 15.4442 17.7618 -6.39245 0.962418 13.4848 -292 1 11.1953 8.50068 16.6178 -6.68582 -9.72424 -8.69684 -293 2 10.4052 8.01271 16.3331 5.65618 1.52157 -2.37675 -294 2 11.7201 7.85843 17.0918 5.14472 -5.56789 7.7477 -295 1 3.97964 18.2216 16.8609 -11.5365 11.132 -5.80894 -296 2 4.44261 17.5481 17.3724 7.79342 1.98205 9.06349 -297 2 4.16759 0.471834 17.2017 1.31413 -17.4358 -0.663005 -298 1 2.27286 4.25928 8.9046 8.30035 -0.830932 12.3077 -299 2 3.22373 4.0264 8.87035 -15.4899 4.40379 3.11293 -300 2 1.97207 4.14495 9.83591 10.7423 -1.42059 -17.2737 -301 1 9.92348 10.3926 9.8203 -1.21029 -1.85278 -24.2235 -302 2 9.36782 11.1029 9.49607 0.630055 7.16446 -2.16893 -303 2 9.82869 10.3844 10.7566 4.49005 -1.30636 29.4196 -304 1 9.77911 0.915187 10.8241 -1.58049 4.53496 -1.50662 -305 2 9.30516 0.126632 11.1017 -0.152878 -7.87834 6.94802 -306 2 9.15539 1.38664 10.2518 4.51752 0.176684 -4.82426 -307 1 9.1489 15.1729 10.179 6.96198 -6.50551 5.53221 -308 2 8.91001 15.8322 9.53904 -4.06695 15.478 -9.20984 -309 2 8.38415 14.5913 10.1616 -4.75674 -5.76082 4.02117 -310 1 0.743465 9.68917 10.1631 30.9903 9.57445 -5.37239 -311 2 0.884314 10.6156 10.4664 -8.35327 -15.1374 -2.2352 -312 2 1.62506 9.41264 9.82336 -24.2866 3.90606 7.18729 -313 1 17.1113 4.7779 8.02102 2.26389 -23.2748 8.45538 -314 2 16.3418 5.309 8.21811 -5.84575 9.78705 2.38191 -315 2 17.0463 3.99595 8.60382 3.74785 14.695 -9.14029 -316 1 14.847 14.6269 0.171171 -19.7527 -14.4968 -14.2937 -317 2 15.5321 14.9161 0.755334 10.0132 13.2257 15.972 -318 2 14.1228 14.2968 0.729437 5.50655 3.69994 -2.14986 -319 1 3.90456 11.0507 9.5998 -4.69832 -0.998696 -0.0493525 -320 2 3.86255 11.1688 10.552 1.28841 5.10968 9.84865 -321 2 3.27063 11.6917 9.24194 0.0177884 -1.71993 -8.82733 -322 1 11.433 10.7439 1.41897 29.5023 2.97313 10.7876 -323 2 11.6019 11.6536 1.12948 3.85703 -2.03295 -2.25776 -324 2 10.504 10.6413 1.35913 -35.0433 -4.68689 -6.35229 -325 1 13.1835 7.21214 12.6412 -8.23521 -20.1104 -3.47812 -326 2 14.127 7.05932 12.5127 3.33109 -0.638199 4.03042 -327 2 12.8061 6.29857 12.6985 3.22225 19.9882 2.50286 -328 1 9.65928 1.95745 0.843925 10.2182 6.36996 -3.06277 -329 2 8.81763 1.63483 0.51897 -5.65357 2.11518 2.03686 -330 2 10.1334 2.26536 0.0610097 2.29468 0.231167 4.03759 -331 1 10.5974 13.4461 4.57973 -2.39764 -3.17335 8.92217 -332 2 11.4415 12.9723 4.66721 0.170993 3.79528 3.71784 -333 2 10.3828 13.7711 5.47244 5.6647 1.39651 -7.04866 -334 1 14.5805 1.64306 10.9903 3.01891 29.9103 -7.34195 -335 2 15.4206 1.31489 10.661 2.43812 -13.4824 -3.17866 -336 2 14.6923 2.61327 10.8523 -8.77415 -13.7688 6.87151 -337 1 14.4577 12.0498 11.5485 -29.7481 -1.24334 12.4997 -338 2 15.1787 12.3182 10.9897 13.6492 5.38623 -14.4259 -339 2 13.7324 11.7114 10.9784 17.3586 4.51945 3.50834 -340 1 8.16823 5.15587 9.894 -28.9634 21.8059 19.126 -341 2 7.25961 5.26999 10.2972 28.5921 -4.04796 -11.5402 -342 2 8.23961 4.23455 9.67377 -1.01689 -19.4985 -4.69706 -343 1 1.66839 17.0027 18.4477 20.9596 26.331 -27.2012 -344 2 2.19503 17.5247 17.7665 -16.8758 -18.2972 22.1195 -345 2 1.83767 16.0826 18.2308 2.67698 -10.8321 1.22526 -346 1 1.40907 17.4029 15.3161 -1.8056 14.8407 8.29727 -347 2 1.4134 18.2156 15.8633 3.96238 -8.68525 -7.97287 -348 2 0.471831 17.1989 15.2085 1.34275 -7.61847 -1.46046 -349 1 3.49459 5.75594 6.06077 -10.0958 -15.2551 6.44531 -350 2 3.00844 6.4276 6.56158 3.56089 -0.0685925 -1.76679 -351 2 4.03572 6.19023 5.40706 10.0519 13.1926 -8.23224 -352 1 12.6765 9.5142 14.2706 -5.75697 27.7722 -14.2581 -353 2 13.0673 8.79775 13.7668 1.15853 -14.5514 3.26719 -354 2 12.382 9.20431 15.1249 -1.95515 -14.6959 8.85488 -355 1 4.11243 15.2112 7.12768 13.4261 4.57048 -4.21166 -356 2 3.68336 15.9917 6.77855 -13.243 7.84695 -2.74865 -357 2 5.05149 15.4218 6.9541 -4.34911 -9.58911 5.5273 -358 1 0.807347 8.85082 15.1137 12.1653 -16.291 -5.21716 -359 2 0.579225 9.7725 15.0704 -11.1033 15.5539 4.56692 -360 2 1.61112 8.83255 14.5724 -2.7466 -7.45742 -2.63208 -361 1 12.955 8.28126 10.1315 4.47425 -26.4789 2.77461 -362 2 13.6724 7.69661 9.75218 -12.3213 15.4477 18.6624 -363 2 12.7996 8.04439 11.0766 12.5165 -4.13221 -14.8671 -364 1 15.2413 7.99312 3.46307 21.2061 37.6089 -22.4299 -365 2 14.4756 7.7211 2.94477 -5.95544 -17.8301 8.14742 -366 2 15.6187 7.46858 4.17258 -15.9179 -18.0198 8.83427 -367 1 17.1356 6.70525 18.6386 6.47512 25.7091 -12.2215 -368 2 16.6963 5.89525 0.233999 -10.309 -8.75159 3.76643 -369 2 16.4339 7.33237 18.3357 11.2115 -13.3479 10.1501 -370 1 8.91981 7.02641 7.93476 -17.5815 -13.9195 9.00305 -371 2 9.83812 7.25537 7.853 19.0031 7.73693 -0.560136 -372 2 8.849 6.45385 8.72921 -1.20537 6.38433 -11.1549 -373 1 12.4784 0.471427 1.2 -1.5382 -11.3036 2.52426 -374 2 13.1724 0.955828 1.65737 6.96212 2.95671 -0.139484 -375 2 12.8855 0.124586 0.40059 -1.81614 4.12295 -0.743523 -376 1 5.7338 15.0104 14.483 3.21537 -3.99883 -6.81615 -377 2 4.79914 15.0689 14.6899 -13.3072 1.49299 3.3932 -378 2 6.00174 15.8892 14.196 3.10174 7.95604 -0.192962 -379 1 3.73322 6.46389 1.74186 4.97145 -11.2752 -15.478 -380 2 3.41061 7.27444 1.33141 -3.85483 5.16021 2.72417 -381 2 3.71896 6.61791 2.68352 1.01313 6.07651 8.98471 -382 1 3.85612 11.3357 12.3214 9.74989 2.64833 3.1782 -383 2 4.70398 11.747 12.5616 1.03181 -4.89631 -4.08494 -384 2 3.21292 11.8498 12.8111 -10.0411 9.11388 1.93155 -385 1 5.31882 3.86098 15.7247 -14.6622 43.9235 8.42988 -386 2 6.03513 3.29574 15.4808 24.4173 -17.8012 -3.50674 -387 2 5.69837 4.77513 15.8552 -8.87612 -28.0013 -6.19005 -388 1 14.0506 10.0984 4.70507 12.9021 5.9963 -48.2497 -389 2 14.373 9.82203 5.54065 6.42583 -15.3441 32.1568 -390 2 14.6577 9.66966 4.04903 -16.6446 6.96016 16.1133 -391 1 7.63016 17.2999 9.07082 4.88589 -1.83029 4.08955 -392 2 7.05774 17.6443 9.76408 -9.77236 -5.61109 0.722829 -393 2 7.90646 18.0745 8.58282 6.82018 7.73796 -12.3688 -394 1 4.54853 14.4989 3.92298 4.51049 -12.0827 -19.4455 -395 2 4.48676 15.3439 4.34231 1.7531 23.2793 6.06498 -396 2 4.47875 13.8474 4.61218 -0.893081 -14.6097 11.9436 -397 1 14.1162 7.44072 15.859 5.72353 -2.97717 1.52707 -398 2 14.8925 7.45204 15.2793 -3.03398 0.324075 5.79835 -399 2 14.4079 7.84098 16.6936 -1.38652 -1.7593 -3.67135 -400 1 2.91046 18.3824 1.92161 -14.6763 12.8451 -3.99897 -401 2 2.56811 17.7851 1.23066 -1.64793 1.84374 10.7046 -402 2 2.14175 0.293363 2.23042 22.3557 -16.8939 -8.97037 -403 1 8.00583 1.57089 4.46736 31.4122 8.97246 -10.4438 -404 2 7.40416 1.98491 3.8452 -8.42929 2.78546 -1.25861 -405 2 8.8818 1.75969 4.05638 -17.375 -7.71187 12.4181 -406 1 2.50572 14.1939 17.7606 -21.3738 -1.77578 0.320632 -407 2 1.88811 13.4733 18.0291 6.14349 16.4853 -5.08899 -408 2 3.36784 13.821 17.8832 22.941 -11.7322 7.4453 -409 1 0.984409 1.95477 13.9081 14.9076 0.866869 -10.4657 -410 2 1.09683 1.70126 14.8211 1.02253 -2.39927 14.2505 -411 2 18.6933 2.04344 13.7674 -16.8072 2.56857 -0.576968 -412 1 4.29327 0.177122 13.8951 16.4248 3.49785 -13.6548 -413 2 5.17049 18.4046 13.9646 -5.43827 4.9033 -2.01246 -414 2 3.78721 18.4389 14.598 -10.2443 -5.04864 16.3534 -415 1 7.35353 0.990853 18.4538 -34.7507 -7.39683 16.7648 -416 2 7.55815 0.737816 17.5561 -3.16307 -6.20953 -15.156 -417 2 6.35665 0.974064 18.6083 33.4978 7.02218 -7.3799 -418 1 15.8311 18.4256 13.8966 -40.0758 9.01377 -20.0242 -419 2 14.87 18.5763 13.7207 27.6408 -4.60797 -2.68704 -420 2 15.8417 18.2976 14.8321 10.6174 3.57585 21.6768 -421 1 10.2864 4.58419 16.2444 -24.4222 -37.2091 -9.88285 -422 2 11.2299 4.68793 16.3674 13.142 -4.29349 -1.09379 -423 2 10.1171 3.59079 16.124 8.18179 40.05 5.52806 -424 1 15.8917 17.7071 4.46459 -20.0388 -20.4222 2.09772 -425 2 16.4651 18.4471 4.57513 18.3163 24.2221 3.8588 -426 2 15.0409 18.0029 4.83395 4.42355 -1.752 -6.47073 -427 1 6.88773 17.6166 13.9821 -38.4037 0.167583 13.1844 -428 2 7.46394 17.6315 14.7417 15.8748 3.42447 12.5511 -429 2 7.41699 17.4009 13.2391 27.9809 -3.71977 -23.5355 -430 1 13.1764 6.43911 6.52144 -5.83912 -0.258919 -12.4557 -431 2 14.0695 6.77261 6.34605 -1.47407 -3.35023 -0.470203 -432 2 12.7466 6.3372 5.63472 11.513 2.45032 19.1456 -433 1 7.86196 2.29978 9.4638 -2.97627 -2.7765 -21.1046 -434 2 7.31086 2.09746 10.2267 -8.88065 1.6173 3.7395 -435 2 7.37564 1.98398 8.66115 7.69705 6.95472 18.2428 -436 1 15.1916 14.7366 13.8236 -12.2847 5.72199 -1.13466 -437 2 14.8954 15.0381 14.6996 2.36081 -1.57038 -3.3629 -438 2 14.579 15.1371 13.1848 7.3504 -2.29354 4.97967 -439 1 9.39483 8.42303 3.86324 -21.5436 -11.8424 -10.9865 -440 2 10.2164 8.84977 4.07537 16.3384 7.87643 5.27894 -441 2 9.57157 7.47345 3.83359 1.44741 0.673327 1.03302 -442 1 17.655 13.5671 16.4489 -7.58846 13.4511 -15.7424 -443 2 16.7203 13.3469 16.3992 -7.59268 -4.18946 5.70215 -444 2 17.688 14.4057 15.9472 10.2114 -8.11811 3.61388 -445 1 4.94979 10.486 2.86622 25.3355 -10.7625 -10.0508 -446 2 5.84023 10.0991 3.03563 -22.0316 6.96347 2.01482 -447 2 4.71704 10.9487 3.67532 0.603793 8.46932 2.75775 -448 1 3.68042 8.39717 9.8747 -7.87972 -17.3414 17.5888 -449 2 3.759 9.34077 9.71499 3.24219 9.53521 -0.886609 -450 2 3.55014 8.28216 10.8428 3.92085 5.02512 -16.6805 -451 1 15.9973 6.92061 5.87772 4.82031 -5.03924 3.59177 -452 2 16.6812 7.41263 6.34454 2.21588 0.961055 0.440265 -453 2 16.3186 6.0008 5.83915 -7.41322 12.2727 -5.03736 -454 1 15.3004 7.2666 8.94213 -32.1238 -12.1179 -31.7334 -455 2 15.9839 7.55437 9.51768 24.5834 17.5628 17.3411 -456 2 15.1488 7.91682 8.21973 7.72693 -8.10504 16.1569 -457 1 6.21705 12.8062 12.747 -22.7002 13.2796 -10.093 -458 2 7.05571 12.494 13.0465 21.6431 -16.5072 9.89045 -459 2 6.01919 13.5682 13.3077 2.09027 1.41895 1.21426 -460 1 12.1299 4.57596 13.1432 22.4432 17.9492 20.1123 -461 2 12.1793 4.58175 14.1216 4.56317 3.76233 -12.2652 -462 2 11.3861 4.04706 12.9369 -26.6961 -18.2025 -7.73732 -463 1 11.4375 8.07047 7.90979 27.6542 -15.5792 16.7856 -464 2 12.1952 7.52933 7.56059 -23.0528 10.899 -6.13628 -465 2 11.6627 8.11033 8.86659 -7.72222 6.32108 -19.0792 -466 1 16.9453 10.7968 7.63148 -3.5821 -10.5143 21.6719 -467 2 17.6495 10.1525 7.46889 2.86773 -0.504685 -4.5375 -468 2 16.8108 11.3218 6.85057 1.29813 10.4979 -20.4226 -469 1 5.19425 18.0282 10.6847 0.056878 3.62778 8.77145 -470 2 4.66571 17.4143 11.2104 4.95394 3.09506 -2.12913 -471 2 4.57063 18.3664 10.0251 3.33377 -5.62986 -0.929046 -472 1 7.60987 17.4226 1.56636 -8.76834 11.2024 10.6057 -473 2 8.12097 16.6429 1.35059 3.07922 -5.96866 -14.3061 -474 2 7.62904 18.066 0.842261 4.5937 -2.56699 -0.219584 -475 1 1.93734 12.9421 13.6328 4.51097 2.01356 -10.2989 -476 2 1.33249 12.4003 14.1383 -4.04092 -5.16916 8.28012 -477 2 2.1441 13.7105 14.1828 3.43289 -0.0153047 1.69165 -478 1 9.36109 6.77295 14.8254 28.0404 -16.4025 -23.0383 -479 2 9.79586 5.92856 15.0909 -10.7826 13.1246 6.51236 -480 2 9.73683 6.91972 13.9197 -17.1545 2.79671 17.5547 -481 1 15.2759 4.38629 10.7467 0.911226 -10.0818 1.35121 -482 2 16.2063 4.08729 10.7712 -9.28003 7.88291 1.38983 -483 2 15.15 4.95989 11.5268 6.34994 -5.62458 -10.0329 -484 1 11.4488 6.21672 0.0274361 8.35139 15.4334 1.07365 -485 2 11.547 5.26836 -0.0918922 -6.12153 -5.65013 -4.62095 -486 2 10.5221 6.46299 18.5238 -1.7877 -10.3718 -2.04901 -487 1 18.4903 11.4194 14.9121 8.77287 -18.4144 -27.074 -488 2 18.1021 11.8559 14.1353 -5.2902 0.217957 4.39134 -489 2 18.3331 12.0271 15.6113 -5.23497 22.6985 22.6894 -490 1 7.12593 9.28496 7.31024 -23.9992 -6.07508 6.39318 -491 2 6.74279 8.45494 7.66169 4.89732 10.9664 -5.80838 -492 2 8.06011 9.1434 7.29118 23.2007 -3.69072 -2.70719 -493 1 18.3302 15.3588 12.1663 1.84912 0.0598217 5.47138 -494 2 0.628985 15.4631 11.9685 -1.01298 4.74778 -2.81479 -495 2 17.8359 15.8974 11.5264 -1.18931 -3.22386 -0.556154 -496 1 16.5345 4.36456 5.22425 -62.6276 -15.6665 42.2949 -497 2 16.4135 4.0372 6.15475 14.4043 4.47956 -24.0603 -498 2 17.4334 4.499 5.03806 48.2264 1.34274 -11.6623 -499 1 17.733 3.12037 10.7685 2.78093 13.2032 15.2159 -500 2 18.62 3.27348 11.1411 -3.87004 4.46435 -8.2182 -501 2 17.7411 2.21797 10.4818 -1.03268 -21.1847 -12.2715 -502 1 12.2988 18.6545 10.1426 21.4258 -12.4002 -10.8053 -503 2 11.5002 0.459945 10.3706 -28.4452 4.23152 6.39845 -504 2 12.9389 0.72089 10.1511 12.8533 4.08749 0.539844 -505 1 10.4313 9.72872 12.541 3.98701 -3.38274 8.58973 -506 2 11.1703 9.84044 13.1623 -1.01011 3.74187 -3.45859 -507 2 10.4039 8.77038 12.4204 -3.66163 0.188688 -4.07709 -508 1 0.615048 2.63664 7.2276 -9.26807 24.3162 -18.5585 -509 2 0.353188 3.56967 7.37092 2.19049 -16.4853 1.00686 -510 2 0.949026 2.32684 8.06684 4.15829 -4.72879 9.31366 -511 1 0.333537 15.2707 6.93805 -1.63763 -14.4268 -44.2284 -512 2 0.559673 15.3175 7.85021 9.94673 -3.51892 30.6084 -513 2 0.629693 14.3791 6.62643 -7.55161 17.6489 9.10591 -514 1 17.0527 6.91364 14.9743 11.0217 0.359412 -1.38417 -515 2 17.7989 7.54943 14.9113 -7.11537 -10.2599 3.19545 -516 2 17.3979 6.08953 15.3732 -1.90278 10.2985 -1.25317 -517 1 9.14167 12.5321 7.98456 -51.8007 8.58975 -7.36144 -518 2 9.48882 11.7504 7.57305 13.8522 -18.8219 -15.7166 -519 2 8.22261 12.6161 7.58551 34.0094 -0.937982 16.6367 -520 1 1.15656 1.63828 2.76743 -9.76481 2.77041 -4.10292 -521 2 0.864287 2.18836 2.03128 -7.19413 -5.97378 -5.55322 -522 2 1.70002 2.22125 3.28253 11.7483 7.29404 14.7886 -523 1 4.17339 15.1305 9.84913 -14.3711 5.0779 2.99988 -524 2 3.91961 15.3463 8.93389 10.9385 -4.50851 5.90843 -525 2 5.03476 14.6902 9.78793 -0.575875 2.49321 0.528438 -526 1 7.3951 2.27992 14.8377 -1.12966 16.8522 -8.99686 -527 2 7.16414 1.54106 14.2639 1.26623 0.276941 -0.531744 -528 2 7.65338 3.03331 14.2573 -5.05472 -19.0282 8.30824 -529 1 18.3172 14.5403 2.1483 15.3986 5.40572 3.08201 -530 2 0.535799 14.8642 2.50804 -16.0996 -1.12956 -11.071 -531 2 17.7238 15.3001 1.99479 6.48993 -0.927096 4.3539 -532 1 10.0475 2.68059 12.9077 -3.02015 -13.9614 -15.6621 -533 2 9.89167 2.00033 12.2018 7.6523 15.7956 13.7679 -534 2 9.26985 3.25658 12.875 1.66072 1.15674 0.355625 -535 1 2.93978 8.85687 13.107 17.7725 7.3386 -7.69378 -536 2 3.37522 9.71823 12.8547 -12.3312 -24.1388 6.15133 -537 2 3.67473 8.22279 13.2377 -8.38529 8.44125 1.12687 -538 1 3.27106 8.61507 3.79074 -8.49716 -38.7584 59.7131 -539 2 3.66196 9.22584 3.22278 26.3747 36.1018 -32.8858 -540 2 3.70281 8.77413 4.67945 -18.9434 -3.96308 -29.2422 -541 1 5.92777 7.2521 8.64891 -10.8881 -6.62505 3.42768 -542 2 5.84919 6.30478 8.465 1.79189 -1.90292 -1.42585 -543 2 5.07694 7.48175 9.0605 5.83384 2.94932 1.14829 -544 1 14.8827 1.64134 1.82872 -12.6885 -28.1567 -9.76357 -545 2 15.1087 2.39997 2.36476 0.314968 13.4446 -1.58597 -546 2 15.1034 1.73075 0.884031 8.80659 10.9019 15.543 -547 1 8.66156 14.9913 0.655877 15.6167 -4.79217 23.7466 -548 2 9.42437 14.9505 1.28455 -14.0351 0.988592 -13.753 -549 2 7.99981 14.403 1.0655 -3.22335 6.28365 -6.24421 -550 1 15.4067 1.46647 7.20695 -8.82589 -12.8718 -0.882757 -551 2 14.775 0.932663 6.69065 9.74374 4.52972 3.50353 -552 2 14.8641 2.16562 7.57814 -1.0399 11.0322 0.525673 -553 1 4.92475 12.8978 18.4559 2.19674 -3.23744 10.1082 -554 2 5.23586 12.8997 0.738081 -1.33722 2.66651 -10.6279 -555 2 5.70033 13.1343 17.9365 -0.0827318 6.23371 -0.0935372 -556 1 15.3819 8.68528 18.0932 8.72121 10.5448 -14.8557 -557 2 15.8142 9.23534 17.405 -7.78496 -12.8196 8.73029 -558 2 15.2566 9.31777 0.164984 -6.85428 -0.586954 10.5179 -559 1 12.0126 3.13082 18.276 9.47145 -1.72319 12.159 -560 2 12.2482 3.16999 0.564179 -5.55591 0.644277 0.165862 -561 2 12.5655 2.41012 17.9461 -5.90061 -0.236568 -11.7395 -562 1 13.2006 12.6959 5.14014 6.0546 -4.02499 4.06103 -563 2 13.6294 11.8271 5.0147 -6.69767 7.2237 -2.15456 -564 2 13.3727 12.9234 6.07289 -1.67526 -4.52376 -7.3865 -565 1 6.1651 7.14436 0.195504 -22.0894 -12.2339 1.18179 -566 2 6.12052 8.09409 18.9477 10.183 13.9972 -1.43251 -567 2 5.2591 6.87987 0.448218 12.567 -4.05161 -1.41715 -568 1 17.6881 15.878 14.8655 -1.85909 5.77814 22.6605 -569 2 16.7739 16.1608 15.0761 11.3822 -6.39517 -19.8211 -570 2 17.8371 15.675 13.9293 -11.1648 4.64831 -4.02463 -571 1 13.1067 0.88062 16.8301 -1.16362 5.09418 6.26073 -572 2 14.0188 0.56665 16.8428 4.80395 1.33473 -1.08149 -573 2 12.5822 18.7235 16.7479 -0.784604 -6.20947 -5.79489 -574 1 10.8701 14.5014 7.48366 30.6398 4.5327 -13.288 -575 2 10.1924 13.8927 7.76637 -8.27046 -6.89901 6.40521 -576 2 11.688 13.9665 7.40985 -13.0568 5.23738 5.47236 -577 1 17.7216 8.3975 2.13341 -5.03714 18.392 15.6468 -578 2 16.8261 8.35978 2.51012 1.26608 -2.81583 -3.60077 -579 2 17.7343 7.78208 1.41002 -5.68948 -14.3091 -15.2975 -580 1 12.4651 7.83121 2.02849 6.21002 21.8293 -0.701234 -581 2 12.2371 8.77742 1.88873 1.61752 -16.1639 -0.0618129 -582 2 12.1801 7.35781 1.23988 -4.06145 -2.69746 -4.32972 -583 1 11.9912 14.5504 10.3779 26.255 2.08103 -27.6641 -584 2 12.3772 14.5828 9.46952 -12.6474 -4.22617 24.8662 -585 2 11.0517 14.669 10.2537 -15.8484 3.20565 2.09431 -586 1 6.76727 6.87556 15.5462 0.393734 11.8444 22.477 -587 2 7.69535 7.12306 15.3658 -7.56189 -7.86407 -0.973014 -588 2 6.54154 7.32616 16.388 3.13619 -10.9433 -13.6985 -589 1 7.93405 4.43454 13.181 3.70457 37.9343 33.3332 -590 2 7.23909 4.66367 12.5613 -7.79541 1.00974 -8.53955 -591 2 7.95717 5.24214 13.788 5.6586 -32.0049 -23.1645 -592 1 13.3208 12.2124 14.3278 -1.85908 1.78375 8.34338 -593 2 13.1627 11.2597 14.246 -0.36998 0.633125 0.823702 -594 2 13.6236 12.4909 13.4584 3.579 0.31603 -3.71376 -595 1 14.5678 9.48203 7.30395 8.22624 -5.55489 -6.16459 -596 2 15.3274 10.0218 7.53849 6.73854 1.05081 2.13221 -597 2 13.8344 9.86252 7.77014 -14.2105 5.15772 9.40205 -598 1 12.6689 16.8584 3.2838 3.32354 22.4122 -6.02395 -599 2 12.8251 17.4603 4.02708 -0.185303 -8.85949 -0.0347213 -600 2 12.7374 17.4469 2.50984 -1.71014 -6.46341 4.85536 -601 1 0.984375 7.0735 17.3432 34.0501 -3.91376 2.11413 -602 2 0.125246 6.96907 17.7347 -25.3968 2.18392 3.09576 -603 2 0.950307 7.67775 16.5933 -9.77339 5.8232 -4.41721 -604 1 13.0022 4.84407 15.777 5.081 -10.3329 -5.56354 -605 2 13.7485 4.25418 15.5901 -10.0146 -2.33354 7.04552 -606 2 13.4521 5.67804 15.8535 -1.12386 24.7122 1.66863 -607 1 2.36131 3.40053 5.10919 -9.6311 -14.0051 -9.38531 -608 2 1.85776 3.14724 5.88615 -5.89279 -11.6191 4.05299 -609 2 2.64546 4.27356 5.34111 14.5219 19.3293 2.74972 -610 1 8.16093 10.9198 13.7208 -5.48668 -10.5203 36.1407 -611 2 8.01338 10.5218 14.6488 11.4544 18.6016 -43.3573 -612 2 8.9553 10.5154 13.3405 3.89898 -1.19123 3.66799 -613 1 13.0685 1.50992 13.279 -14.1832 25.7313 -25.8855 -614 2 13.6244 1.50815 12.4613 -6.9447 -4.36872 19.5281 -615 2 12.4297 2.25673 13.1075 20.3356 -25.0236 11.2619 -616 1 6.62047 13.6375 2.07221 -5.18984 1.0977 1.00923 -617 2 6.01355 14.0796 2.67998 -4.17105 4.32933 -3.39809 -618 2 7.10668 13.0566 2.65885 8.90022 -6.51269 2.26225 -619 1 15.8066 6.3469 12.5124 13.7748 11.2213 20.1038 -620 2 16.2844 6.87459 11.8544 0.57451 -1.64399 2.92177 -621 2 16.2805 6.52872 13.3684 -12.0243 -5.9969 -18.7155 -622 1 16.7622 0.649503 9.5351 11.3629 -0.534141 16.2257 -623 2 16.8233 18.3334 9.63984 -7.20854 -2.096 2.62458 -624 2 16.3504 0.825019 8.69009 -8.20455 0.909068 -17.3039 -625 1 6.16155 11.6721 8.23727 11.0478 -14.7079 4.32064 -626 2 5.37204 11.4355 8.7099 -18.5694 3.37101 8.66714 -627 2 6.52549 10.7898 8.06052 6.85938 7.24602 -7.48704 -628 1 2.80718 8.60686 0.397493 -27.1124 -12.7057 -15.0387 -629 2 2.16203 8.12721 18.4284 20.3601 19.9434 23.0266 -630 2 2.28863 9.2379 0.937046 1.66532 -5.5958 -10.4069 -631 1 10.1061 10.2794 6.574 -2.68384 6.39054 8.98367 -632 2 10.587 9.61275 7.07222 2.60765 -6.52577 4.24337 -633 2 10.6348 10.4062 5.77746 -5.53346 0.236498 -3.27199 -634 1 6.84319 15.7735 6.74802 2.92919 -7.52667 3.13791 -635 2 7.22287 16.2754 7.48672 -6.2609 -2.86584 0.474311 -636 2 7.16745 16.2182 5.95944 -1.73758 9.59963 -7.48558 -637 1 6.59004 12.8453 5.92771 5.9232 5.70246 -10.7633 -638 2 6.81648 13.7523 6.14266 -3.08056 9.02497 3.95142 -639 2 6.18071 12.4806 6.71128 -2.95494 -1.85994 5.08984 -640 1 16.7187 12.5557 9.81602 -6.97981 -8.42056 3.44329 -641 2 16.7367 11.9049 9.10465 3.04519 -4.31121 0.702836 -642 2 17.0063 13.3635 9.40922 2.88649 12.8114 -1.84814 -643 1 6.30344 2.78963 2.73877 -9.04367 -13.9111 -2.70816 -644 2 6.4136 3.72217 2.50807 2.58545 1.58307 -3.30667 -645 2 5.8765 2.3355 1.98292 3.38351 11.0448 5.4768 -646 1 10.696 2.92954 3.25253 -4.78239 0.546409 -3.48797 -647 2 10.285 3.77274 3.47459 -3.26512 -0.523652 -3.33277 -648 2 10.2907 2.61783 2.41902 1.90367 1.74508 6.25714 -ITEM: TIMESTEP -100 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.7952 6.55188 17.82 -14.0925 -19.7636 -3.75378 -2 2 7.88023 6.44026 18.1695 19.5523 6.07432 -5.80163 -3 2 8.99571 5.7855 17.2401 -2.64216 11.7935 9.74201 -4 1 0.13387 8.39658 6.71777 11.0686 -17.0219 51.8315 -5 2 0.297964 8.15416 5.82611 3.65759 -8.78146 -34.4276 -6 2 0.663997 7.73523 7.26654 -21.1289 27.238 -19.6589 -7 1 8.71966 0.469223 7.04147 6.63626 1.40123 -3.67752 -8 2 9.62406 0.435013 6.6778 -11.0722 1.83914 2.93454 -9 2 8.2146 0.970711 6.38506 4.19741 -2.20649 2.49068 -10 1 6.44826 1.6863 11.7796 22.1018 -16.0737 -10.0998 -11 2 5.81214 2.23354 12.2013 -20.9633 15.3476 12.0772 -12 2 6.02072 0.836228 11.6256 -4.8988 -3.15305 -3.34718 -13 1 6.89097 5.45035 2.38694 -14.0878 18.1315 0.804401 -14 2 6.23022 6.01625 2.92115 27.2653 -21.4077 -23.7527 -15 2 6.91491 5.77412 1.45583 -9.40281 2.39732 25.4334 -16 1 16.2334 10.2315 16.0664 1.22095 -12.8583 -8.35396 -17 2 17.1105 10.2758 15.679 0.521344 2.88453 0.293596 -18 2 15.9464 11.1361 16.1778 -3.48259 10.2735 3.78324 -19 1 10.8573 15.0007 2.35193 -8.17785 -20.274 -7.01899 -20 2 10.8024 14.5151 3.19219 -3.98998 0.859093 -1.88791 -21 2 11.3201 15.8014 2.5578 8.92048 16.4226 10.3474 -22 1 17.1726 8.21805 11.024 14.0848 -19.0512 -23.2094 -23 2 16.691 8.91369 11.4632 -8.36385 12.6057 9.94503 -24 2 17.8921 8.64427 10.518 -5.71892 -0.131476 8.97419 -25 1 14.5956 15.9799 16.3132 20.7515 -13.8502 3.42179 -26 2 13.7469 16.3872 16.1713 -21.6627 3.23661 7.28294 -27 2 14.5521 15.3865 17.0935 -1.40849 8.21009 -3.21798 -28 1 12.1509 13.2395 0.573493 6.57205 3.5904 2.72349 -29 2 11.837 13.3986 18.3303 -3.80405 -1.74926 -15.723 -30 2 11.7012 13.9105 1.09717 -2.12612 0.929616 9.94365 -31 1 9.32377 5.48511 3.80515 37.2224 0.919853 24.8976 -32 2 8.88878 5.295 4.65312 -11.8166 2.00864 -7.28102 -33 2 8.70235 5.44743 3.10202 -35.0307 -2.6733 -15.0358 -34 1 1.53449 3.88906 11.5762 -21.4592 42.8438 -26.3691 -35 2 1.39761 4.77552 11.9865 7.05639 -9.88004 -9.22537 -36 2 1.89707 3.34621 12.2331 21.1403 -27.4328 37.6181 -37 1 2.11621 6.94729 8.0812 -5.52003 -16.2776 -1.04121 -38 2 2.5746 7.45442 8.7366 8.45236 15.6822 11.2536 -39 2 2.08388 6.07661 8.50513 -4.57751 -6.44388 -7.47435 -40 1 5.24695 4.43578 7.8028 -6.30612 26.2857 -2.69952 -41 2 5.36677 3.49844 7.65426 0.215716 -12.5366 -1.65761 -42 2 4.56392 4.76953 7.18377 10.1949 -9.65667 2.91339 -43 1 3.43524 2.88686 17.4376 -21.7675 5.87472 14.6558 -44 2 3.90981 3.17382 16.6701 17.8952 10.4272 -14.0542 -45 2 2.87759 3.6541 17.6984 8.18662 -9.04753 2.1829 -46 1 7.55778 5.57378 6.15352 3.99821 9.40639 19.9011 -47 2 8.12518 6.20749 6.66299 -12.9927 -14.0765 -9.88952 -48 2 6.98227 5.15891 6.82729 7.75312 -1.10557 -10.9113 -49 1 9.77611 7.00478 12.0482 -6.90333 -2.64414 -8.04886 -50 2 10.0224 6.11753 11.7611 0.642082 2.81741 -0.891425 -51 2 9.0843 7.2891 11.4183 2.80801 -0.947675 5.79882 -52 1 14.1423 3.90191 8.16294 -23.6925 4.35767 -24.2753 -53 2 13.5235 4.53411 7.72337 18.2577 -11.8103 7.89417 -54 2 14.4024 4.31063 8.97869 6.95814 7.70003 16.5888 -55 1 4.54437 17.2359 3.8519 4.03565 10.1791 3.31349 -56 2 5.34213 17.7268 4.08304 4.36901 -6.62302 -0.267376 -57 2 4.17051 17.7127 3.09453 -6.96766 -2.87365 4.53203 -58 1 16.1339 16.4921 10.5971 24.4543 -12.0388 -34.7313 -59 2 15.4578 16.6815 11.2098 -23.1752 5.77424 26.3474 -60 2 15.6745 15.9439 9.92709 9.81353 9.26167 7.23238 -61 1 1.98282 4.87023 -0.0102057 11.328 -31.2723 15.691 -62 2 2.56866 5.25094 0.666382 -3.10152 5.14206 -1.69339 -63 2 1.65849 5.5885 18.1127 -8.58794 22.0564 -11.6074 -64 1 11.0975 13.3336 16.4568 21.334 -26.4555 -13.6253 -65 2 10.7319 12.43 16.5661 -7.83355 14.7592 4.38577 -66 2 11.7328 13.1734 15.7328 -3.59268 8.82171 6.12988 -67 1 9.983 10.9188 16.8195 21.8027 -17.9597 14.5818 -68 2 10.5015 10.1139 17.0687 -12.258 16.9146 -11.8156 -69 2 9.08607 10.6082 16.6912 -8.94921 1.38614 -3.26281 -70 1 11.9148 17.5563 13.4787 -11.9158 -12.5975 -1.23623 -71 2 12.5676 17.2101 12.8515 -0.0246338 2.67811 4.16536 -72 2 12.0003 18.5089 13.4756 8.75914 10.3848 -3.31648 -73 1 6.43245 9.54572 12.2957 1.63429 -3.34072 -14.2423 -74 2 7.08046 9.15867 11.6656 -10.0512 7.63496 6.98562 -75 2 6.90317 10.1892 12.8448 2.76093 -9.73394 -7.4892 -76 1 16.2985 12.7819 2.78073 -6.76278 9.02259 -0.251856 -77 2 17.1507 13.1937 2.56739 -3.11425 -2.92719 1.79117 -78 2 15.6658 13.5347 2.78258 7.1706 -12.5209 -0.796151 -79 1 0.705375 12.7757 5.80641 -31.4327 0.785322 -26.0818 -80 2 0.964058 12.7408 4.86595 9.86444 -3.28161 8.94612 -81 2 18.3663 12.6813 5.72517 19.7421 -2.33124 11.5636 -82 1 5.30386 16.3127 18.466 5.80758 -1.43031 -6.37222 -83 2 5.80257 15.6526 17.9366 -5.42534 13.184 13.7491 -84 2 5.92544 16.7092 0.45256 -3.43112 -6.46136 -2.11967 -85 1 0.781035 7.63768 4.09742 11.023 -5.93732 13.9838 -86 2 0.258202 7.96457 3.37539 -14.755 3.95315 -10.1558 -87 2 1.66078 7.97253 3.8829 3.26007 -0.00880383 4.41534 -88 1 3.24417 9.16605 6.56429 -20.4701 -14.3326 2.83801 -89 2 3.57159 8.65908 7.31953 1.49107 7.58135 -6.52778 -90 2 2.30098 8.88971 6.4655 20.5558 12.7829 2.43715 -91 1 7.26627 10.4004 16.2591 -15.7562 -6.32656 27.9079 -92 2 6.82075 11.2368 16.4586 5.73239 -2.42146 -6.93429 -93 2 6.93167 9.82605 16.9811 6.22417 8.86745 -10.8084 -94 1 10.9892 0.849679 5.07849 4.12027 -5.76689 -13.93 -95 2 11.0513 1.64213 4.53259 0.725375 9.02843 9.39609 -96 2 10.6504 0.238952 4.4041 -0.868918 -3.08012 11.6628 -97 1 4.18223 2.98976 13.1617 1.80285 -9.79496 -4.9743 -98 2 4.46754 3.28562 14.0477 -4.0491 -7.36491 -7.89898 -99 2 4.03841 2.01285 13.1683 3.67857 16.3758 11.7633 -100 1 8.4888 10.2856 1.85141 10.3375 -10.6918 -8.28538 -101 2 8.43451 10.9691 2.52904 -3.58901 -0.686288 7.94652 -102 2 8.82874 9.48425 2.29142 -6.1923 10.8646 1.43904 -103 1 10.2336 1.64305 15.4458 -13.2429 9.10796 4.38269 -104 2 11.1732 1.63861 15.572 16.9305 -2.55664 -1.17381 -105 2 10.0536 2.05804 14.5895 6.55462 -3.46994 -1.37038 -106 1 2.58993 12.7242 7.97336 -7.23425 -8.94691 3.8681 -107 2 3.01571 13.5704 7.82234 5.57764 5.06786 -6.45979 -108 2 1.98486 12.5774 7.23174 0.806159 4.05811 0.362671 -109 1 3.90685 11.8307 5.02738 -19.955 -7.05304 -0.3571 -110 2 3.70751 11.1281 5.68153 3.09094 12.242 -8.4391 -111 2 3.06715 12.0092 4.53628 19.8771 -7.15241 7.2697 -112 1 6.7679 14.5791 16.9276 2.77817 -6.983 11.0716 -113 2 7.71708 14.7379 16.9268 0.980214 1.28706 0.809355 -114 2 6.44853 14.8723 16.076 -0.709014 -5.22289 -12.1565 -115 1 14.1752 14.508 3.1348 7.33594 -12.7834 -7.22412 -116 2 13.6105 15.2801 3.10139 -3.55206 9.35654 4.80996 -117 2 13.7682 13.8754 3.73922 -4.33905 3.15851 6.00261 -118 1 8.77346 18.0937 16.1268 -49.3086 -19.2657 7.09896 -119 2 9.29148 17.2891 16.2682 10.0054 9.31596 -1.94744 -120 2 9.22615 0.228463 15.833 27.8858 8.66202 -5.29688 -121 1 4.63977 1.75161 4.89947 12.6555 12.3233 -26.7382 -122 2 3.82082 2.25711 4.97207 0.159842 -3.07614 2.23584 -123 2 5.05477 2.09313 4.05862 -7.26402 -10.6651 28.8422 -124 1 15.0293 12.6717 16.5117 -23.31 -0.861404 35.6256 -125 2 14.4426 12.7177 17.3057 24.815 2.28331 -11.4604 -126 2 14.393 12.496 15.8301 -9.60755 -0.359254 -28.8722 -127 1 15.7282 18.4115 16.8424 17.2085 30.6847 -2.58542 -128 2 16.585 18.5255 17.3163 -17.0651 -10.3906 -2.34083 -129 2 15.5073 17.4884 16.7844 1.64687 -19.4864 2.05956 -130 1 1.3653 1.32145 16.674 4.57571 12.7751 22.4809 -131 2 2.22966 1.72757 16.8986 -13.3853 -7.67206 -8.47788 -132 2 0.843747 1.53379 17.4789 2.23908 -6.3926 -16.4011 -133 1 18.2502 4.28823 15.9426 5.59379 -7.24598 -18.3859 -134 2 17.8025 3.49471 15.6029 3.53909 11.4984 4.55434 -135 2 0.380345 4.42598 15.3659 -10.3938 -1.91133 11.4 -136 1 12.0179 17.0993 16.1449 -24.7595 -29.8482 27.6473 -137 2 11.2904 16.5264 16.5371 30.7476 29.6052 -3.96723 -138 2 11.7854 17.0696 15.2267 4.30162 8.23296 -25.5613 -139 1 16.0455 2.77586 18.2041 10.6955 -6.31261 -1.53201 -140 2 15.9135 3.65525 18.5895 -10.0784 -5.09061 -10.2232 -141 2 15.7148 2.7749 17.2908 -2.70848 4.2718 2.75475 -142 1 6.57887 13.7167 10.0128 0.388305 24.4332 24.1101 -143 2 6.2636 13.3347 10.8463 6.37938 -3.40375 -0.55213 -144 2 6.43171 13.0818 9.3305 3.17506 -19.669 -12.997 -145 1 10.1062 18.565 2.71626 12.0596 2.32822 -17.6158 -146 2 10.7563 0.294125 2.0815 -9.9929 -7.47975 8.60443 -147 2 9.2984 18.4331 2.20633 -1.12272 -0.999648 5.59115 -148 1 3.10044 17.6571 6.21769 -0.590198 -1.20238 18.0356 -149 2 2.16339 17.7471 5.9649 14.558 -0.242179 -11.811 -150 2 3.6505 17.6877 5.42436 -8.00238 0.252249 -9.63341 -151 1 12.5899 16.7797 7.85568 11.434 -9.28582 -14.859 -152 2 11.8995 16.1049 7.73478 -4.76829 8.38316 1.604 -153 2 12.3367 17.3735 8.55676 -7.89443 8.69289 16.0625 -154 1 14.8958 15.3252 8.42405 -10.9907 16.0866 -10.412 -155 2 14.2257 15.9607 8.05927 9.60746 -16.915 15.6813 -156 2 15.568 15.2992 7.73812 1.83068 -0.846784 -8.90808 -157 1 17.9236 18.2959 0.16927 -20.6229 -20.5305 -14.2597 -158 2 18.7101 17.7336 18.8116 8.98564 4.8691 -3.01699 -159 2 18.0908 0.428516 0.675884 12.0916 17.8267 11.1415 -160 1 0.800533 10.4853 1.48213 -15.9305 -52.1134 32.1201 -161 2 0.0210499 9.87138 1.72712 35.348 27.3948 -12.4938 -162 2 0.488783 11.092 0.839839 -12.4886 25.7711 -24.5144 -163 1 1.85398 12.3107 3.26054 -2.39029 3.71051 2.5874 -164 2 1.61156 11.5651 2.68837 -2.80207 3.45241 0.205878 -165 2 2.01622 13.0664 2.66785 -2.08994 -5.59574 4.32216 -166 1 0.726068 17.2941 4.97534 23.1964 8.93599 -27.6283 -167 2 -0.00504426 17.9045 4.96895 -11.3657 3.83105 9.40925 -168 2 0.6848 16.6356 5.64734 -16.8394 -17.6158 22.5419 -169 1 0.979774 0.931094 9.39103 18.34 6.67236 9.68687 -170 2 1.13606 0.587208 10.3041 -6.25966 0.627701 -15.4141 -171 2 0.222638 0.493139 9.00427 -6.20505 -6.29115 6.11619 -172 1 16.8132 2.44689 13.4524 12.1018 18.2567 -5.29927 -173 2 16.9941 2.74318 12.5312 -5.60486 -9.11594 12.8952 -174 2 16.5475 1.52939 13.4414 -4.39811 -15.2301 -8.28386 -175 1 2.68823 16.0572 12.0971 4.35106 -7.5731 1.60029 -176 2 3.00862 15.6347 12.9147 -3.00711 3.68751 -12.4652 -177 2 3.25289 15.7623 11.3532 -3.53001 -2.50035 7.7005 -178 1 16.365 15.3972 6.07793 1.10786 -2.726 6.22736 -179 2 17.2616 15.5854 6.39959 0.338369 -3.43469 -2.74975 -180 2 16.1217 16.1306 5.49548 2.77772 2.55878 -2.13745 -181 1 5.71885 5.23685 11.7571 -1.38587 -22.0348 -7.59079 -182 2 5.34065 5.94353 12.2818 1.95161 11.9795 4.35233 -183 2 5.13977 4.47517 11.9216 1.17844 4.76848 -1.31072 -184 1 15.1029 4.9502 0.771222 1.99697 3.13949 16.3358 -185 2 15.0181 4.74755 1.72068 1.03511 -0.706475 -1.64751 -186 2 14.2572 5.32925 0.539529 -7.17443 2.24029 -6.36177 -187 1 16.4241 16.5209 1.77175 11.7834 22.2537 -31.9797 -188 2 16.1353 16.901 2.59837 -3.82757 4.70614 16.3909 -189 2 16.7243 17.3043 1.2165 -7.10171 -29.7856 17.5505 -190 1 0.166785 4.90105 4.02875 -9.807 6.14851 -6.2016 -191 2 0.490919 5.80972 4.19933 1.47178 -10.2493 -2.87817 -192 2 0.85797 4.25703 4.16889 13.481 4.94217 6.1798 -193 1 2.95388 15.1092 15.162 10.7369 -8.35154 -8.83455 -194 2 2.79081 14.8128 16.074 0.0767364 3.70074 1.09557 -195 2 2.55949 15.9866 15.0864 -8.26758 5.41964 7.36053 -196 1 1.08589 14.7081 9.5149 24.8711 -1.95174 9.92838 -197 2 2.02655 14.926 9.73253 -22.6422 -7.57261 -8.5802 -198 2 0.981604 13.769 9.74603 1.17561 7.47496 0.770389 -199 1 13.5787 16.5188 11.5692 -12.2314 13.2219 -8.78769 -200 2 13.3397 17.246 10.9551 -0.181138 -8.24863 9.65793 -201 2 12.9892 15.7954 11.3146 2.83531 -7.80051 -5.41791 -202 1 4.81777 1.55092 0.678258 -26.6156 -3.92273 4.29753 -203 2 4.35705 2.21925 0.160828 3.99581 1.83661 -5.90848 -204 2 4.05187 1.04139 1.04246 22.8613 -3.7169 0.169547 -205 1 1.54475 18.6679 11.892 -7.41525 16.2224 7.56704 -206 2 1.47416 0.586534 12.6867 1.33096 -5.97454 -6.01551 -207 2 1.79005 17.7987 12.209 7.72027 -7.46968 0.191542 -208 1 11.4358 10.1471 4.23265 -10.894 -3.87129 -8.35951 -209 2 11.2613 10.4034 3.31126 9.28636 4.56211 3.82985 -210 2 12.3915 10.0236 4.32197 -4.85978 3.43988 -0.432274 -211 1 8.20336 12.1359 3.88849 -13.0458 16.1374 35.7669 -212 2 8.99874 12.5954 4.16275 16.0075 -1.33649 -14.8839 -213 2 7.69556 12.2697 4.73273 -2.96338 -15.3566 -29.2591 -214 1 14.5957 4.06338 3.37559 11.9385 -4.24509 -11.5663 -215 2 15.1907 4.01381 4.14053 1.35901 4.80596 -1.61984 -216 2 13.7786 4.41816 3.71066 -15.4173 6.10577 6.17301 -217 1 5.71905 1.6749 7.61995 8.80947 6.26404 67.7498 -218 2 5.099 1.08549 8.07836 1.13728 7.44943 0.131268 -219 2 5.55556 1.51371 6.73852 -13.1925 -8.9768 -74.4163 -220 1 17.8986 1.04478 4.82737 2.1754 -1.83476 -0.744307 -221 2 18.4917 1.14925 4.06283 -1.19754 2.46044 8.41233 -222 2 18.3052 1.49477 5.5864 -1.29774 -0.0865267 -3.68542 -223 1 6.84138 9.15652 4.5536 4.1666 1.31036 -3.45285 -224 2 6.90548 9.53593 5.43168 -5.85674 1.32054 6.56912 -225 2 7.76285 8.95875 4.34348 -1.51129 -0.833856 -3.18299 -226 1 2.51554 14.7147 2.08788 -0.0450507 -1.43316 -6.26715 -227 2 3.18184 14.7861 2.78103 3.7873 -1.55841 0.251503 -228 2 3.00277 14.5163 1.27395 -5.30581 6.45149 3.77223 -229 1 17.2192 13.0031 13.0554 -12.0926 -3.19634 4.57291 -230 2 16.3553 13.3969 13.3572 27.3304 0.34804 -8.60607 -231 2 17.7786 13.6982 12.6582 -16.3476 4.90844 7.68697 -232 1 14.8182 10.5634 1.61386 4.26778 13.3748 6.0388 -233 2 15.4677 11.1895 1.9919 -6.32062 -5.48184 -5.48699 -234 2 13.979 11.0422 1.62876 3.88819 -6.35193 -1.63244 -235 1 5.61579 6.74404 4.50101 -16.4591 -25.6922 -2.42498 -236 2 5.98931 7.61359 4.54862 8.72135 21.7956 -0.434523 -237 2 6.18395 6.1944 5.05334 5.89398 3.69136 0.98365 -238 1 7.99723 8.25195 10.2692 14.8304 8.84149 10.0706 -239 2 8.65992 8.88256 9.91656 -9.90097 -8.80766 -1.78449 -240 2 7.59566 7.7759 9.52484 -1.48617 9.19501 4.49734 -241 1 13.4628 18.4324 5.71378 17.6235 1.75148 -9.47684 -242 2 12.708 0.350866 5.56458 -19.7852 7.87128 -2.36248 -243 2 13.2811 17.9777 6.53219 -7.30606 -12.1428 7.93723 -244 1 0.0668655 2.55772 0.44163 -1.64079 -15.5797 1.12414 -245 2 17.7792 2.62308 0.158326 7.01821 10.3157 -4.2768 -246 2 0.560589 3.37114 0.261458 -5.35649 7.7487 -2.70304 -247 1 12.8473 10.8167 9.6749 -29.1069 48.3462 -20.1155 -248 2 11.856 10.995 9.62541 32.1605 -20.6147 5.13184 -249 2 13.0142 9.92242 9.94244 -8.5776 -22.9331 5.75343 -250 1 0.607197 12.3488 11.1216 10.7177 -2.21067 3.69277 -251 2 18.3016 12.4338 11.1296 -15.0263 -0.672926 -5.71109 -252 2 0.887353 12.7089 11.9725 7.71276 -2.01358 -2.19338 -253 1 5.32001 7.36668 13.2938 5.32433 15.1635 7.63099 -254 2 5.70557 8.20602 12.9842 -2.91102 -7.98825 -6.07053 -255 2 5.82609 7.21997 14.1065 -9.96591 -5.08448 1.55341 -256 1 1.1733 6.74916 11.943 -30.749 -23.7015 -12.6924 -257 2 0.265139 7.01822 11.7017 14.0517 -0.957096 2.97943 -258 2 1.61086 7.53614 12.2133 15.6557 23.6476 13.031 -259 1 15.5486 9.75906 12.4999 -0.653644 29.4777 3.96245 -260 2 15.1521 10.5891 12.1135 7.41979 -25.1975 16.8694 -261 2 15.9641 10.0301 13.3422 -9.48671 -5.05259 -12.6364 -262 1 16.5044 12.5382 5.51299 -3.50049 1.7151 -41.7779 -263 2 16.2902 13.4721 5.54585 0.30498 11.7411 21.1442 -264 2 16.3754 12.4207 4.53497 7.77761 -11.637 24.1999 -265 1 6.32544 9.92844 0.21289 -23.4091 -5.64021 -11.1485 -266 2 5.58447 10.3552 0.689761 9.59747 -6.57127 -5.34636 -267 2 7.10511 10.1371 0.71679 14.7949 3.34633 14.2781 -268 1 12.1134 5.97718 4.01208 -22.8865 -14.7559 9.656 -269 2 12.2541 6.73773 3.46345 4.76282 13.7738 -16.8186 -270 2 11.1454 5.80116 3.92348 22.2207 -1.187 3.16864 -271 1 0.310021 12.9061 0.00438974 -4.95288 1.79463 -7.14095 -272 2 18.578 13.473 0.695812 6.768 -1.51286 0.947724 -273 2 18.4929 13.1888 17.8371 0.864006 -6.25549 9.7975 -274 1 3.57649 0.0893425 8.67318 10.7138 1.44606 -23.5182 -275 2 3.53585 18.3471 7.78602 0.204258 -6.73647 -0.0210952 -276 2 2.75019 0.556646 8.71194 -17.5671 6.50862 13.0872 -277 1 7.32229 17.553 4.46711 -1.8346 22.7033 -6.51397 -278 2 7.49747 18.5341 4.60164 1.92735 -36.6431 -12.1684 -279 2 7.43093 17.3591 3.50845 0.44318 8.65947 16.4016 -280 1 9.23372 17.1692 12.2368 -1.40541 18.7929 10.7586 -281 2 9.17923 16.5713 11.4947 6.54031 -16.824 -6.24154 -282 2 10.1445 17.1937 12.5849 -6.50468 -4.83213 -2.69749 -283 1 13.3883 13.1392 7.89062 -8.44361 -29.718 12.0449 -284 2 13.2983 12.3346 8.48336 5.26587 25.8846 -16.8323 -285 2 14.1176 13.673 8.22732 -1.02664 3.48474 5.19869 -286 1 14.8313 2.83639 15.4549 13.5448 -0.0778016 6.35676 -287 2 14.1767 2.18003 15.2177 -4.87233 -8.03631 -4.89691 -288 2 15.4971 2.82305 14.7488 -5.52573 3.83225 -1.21536 -289 1 9.88985 15.6498 16.9162 -1.5178 12.6863 -12.8881 -290 2 10.4068 14.8878 16.6522 -4.3383 -15.6303 0.424585 -291 2 9.57752 15.4658 17.7984 -6.29913 -5.39682 13.2163 -292 1 11.1832 8.45041 16.604 0.69795 7.62392 -5.91094 -293 2 10.4558 7.91494 16.2714 -2.08228 -2.22425 -3.83894 -294 2 11.7364 7.86183 17.1086 3.16052 -9.92137 8.33691 -295 1 3.98058 18.2281 16.8796 4.69725 -6.17709 8.80305 -296 2 4.47544 17.5796 17.4031 -3.04366 -6.21568 -3.2578 -297 2 4.2975 0.415113 17.2284 -3.71051 8.24157 -1.82763 -298 1 2.31186 4.29334 8.90298 15.9673 -19.5394 32.2139 -299 2 3.25638 4.01729 8.88792 -18.4415 10.5974 -6.3491 -300 2 2.00846 3.99585 9.80326 5.50039 13.6474 -24.2252 -301 1 9.93626 10.4071 9.85717 -7.16433 6.26663 -15.7674 -302 2 9.36967 11.1624 9.60099 8.89086 -7.49456 6.1891 -303 2 10.0442 10.3828 10.8072 -0.648607 3.91668 13.0823 -304 1 9.8312 0.910661 10.8223 11.6198 7.73817 -5.63486 -305 2 9.46664 0.0599513 11.0613 -12.5627 -8.03565 7.40448 -306 2 9.23233 1.33675 10.1908 -3.5905 -1.89286 -1.84539 -307 1 9.13587 15.2239 10.1542 8.27875 -9.17261 13.8125 -308 2 8.75897 15.8188 9.50902 -6.94043 7.83547 -6.48358 -309 2 8.46187 14.5466 10.3059 -2.40816 2.69742 -4.7236 -310 1 0.685213 9.67274 10.114 -7.63752 22.5158 18.5003 -311 2 0.719625 10.5209 10.6443 4.69174 -21.4783 -21.4849 -312 2 1.56632 9.47392 9.79675 4.15873 2.44002 -0.184199 -313 1 17.1428 4.74332 7.9842 -7.49261 0.0436566 15.7002 -314 2 16.4923 5.43036 8.24486 9.33931 -9.59151 -5.74994 -315 2 17.1543 4.09081 8.70481 -1.62938 8.73821 -5.69634 -316 1 14.873 14.5838 0.184633 -12.5055 -0.863041 8.47648 -317 2 15.4452 15.0773 0.785336 2.49238 5.2379 -3.7088 -318 2 14.1221 14.3325 0.749692 6.56524 -1.80757 -8.31994 -319 1 3.93739 11.0893 9.63941 -1.02455 -14.3236 -20.6383 -320 2 3.83455 11.1931 10.5803 -4.40039 8.60569 15.1914 -321 2 3.22961 11.5882 9.19534 2.92088 3.20496 1.27781 -322 1 11.4787 10.7372 1.42758 24.3197 -0.772389 9.7934 -323 2 11.803 11.5915 1.09275 -4.97826 -3.71445 3.9898 -324 2 10.5984 10.6629 1.1011 -26.1902 -1.18673 -8.43185 -325 1 13.1873 7.21634 12.6041 -15.1781 -16.7535 7.59792 -326 2 14.1321 7.04558 12.6338 7.66113 -4.04391 -1.22332 -327 2 12.7625 6.33802 12.7657 6.99529 16.5731 -3.03327 -328 1 9.70202 2.01155 0.798053 14.7354 3.6785 18.4689 -329 2 8.80874 1.78739 0.563168 -12.7542 -2.84597 -8.5823 -330 2 10.1462 2.35336 0.0231027 2.1886 1.53799 -6.67264 -331 1 10.5601 13.4177 4.61479 15.5689 5.45852 21.4774 -332 2 11.4398 12.9929 4.68798 -8.71776 0.745444 -2.53542 -333 2 10.4627 13.8549 5.48714 -1.1208 -2.16649 -13.1077 -334 1 14.6135 1.64587 10.9888 -15.9483 2.47769 1.03658 -335 2 15.3653 1.14828 10.6398 3.3395 9.35485 -7.37665 -336 2 14.6055 2.55489 10.6162 9.33106 -12.1869 7.67578 -337 1 14.4205 12.072 11.5247 -14.0438 -11.3661 -21.2086 -338 2 15.2325 12.1783 11.0185 5.83651 11.9615 0.736203 -339 2 13.7775 11.7491 10.8405 12.2041 8.47933 23.407 -340 1 8.16075 5.17074 9.91542 -32.2508 22.4833 15.2463 -341 2 7.26447 5.43351 10.2769 29.6925 -9.34554 -9.10024 -342 2 8.08912 4.23235 9.75273 2.68018 -15.2376 -3.85437 -343 1 1.73754 17.0197 18.4251 17.7604 24.8388 -20.6387 -344 2 2.31535 17.5448 17.7835 -20.2636 -19.608 22.2942 -345 2 1.91865 16.0976 18.2314 3.71033 -9.13614 -1.37747 -346 1 1.38218 17.4352 15.3141 25.6123 -1.10879 -8.05345 -347 2 1.40837 18.2867 15.7687 -7.1514 0.273564 3.63966 -348 2 0.483975 17.1212 15.2601 -14.2857 -2.70278 3.05549 -349 1 3.46713 5.71669 6.03858 -5.21329 -0.208659 9.269 -350 2 3.09179 6.35885 6.66621 -4.29108 -6.04245 -5.71481 -351 2 3.94628 6.22951 5.39233 13.1871 8.33197 -8.25473 -352 1 12.7108 9.52885 14.2713 4.43437 -19.6411 -8.16456 -353 2 13.1132 8.73466 13.871 -3.04318 14.9787 -8.97539 -354 2 12.4252 9.15135 15.1011 -11.0135 5.38653 13.5706 -355 1 4.12803 15.1962 7.19495 12.4066 -8.66704 -3.75127 -356 2 3.59847 15.8823 6.77325 5.03517 9.17322 -2.57748 -357 2 5.08076 15.3227 6.96437 -18.0652 5.77836 0.725546 -358 1 0.842345 8.89099 15.1297 2.31502 -25.1166 0.479797 -359 2 0.506769 9.78853 15.0967 4.66165 8.13805 -4.97691 -360 2 1.56169 8.8202 14.4757 -4.5077 5.49756 1.76436 -361 1 12.9722 8.22706 10.1223 30.4908 -35.0116 2.62512 -362 2 13.7358 7.69898 9.75664 -18.6412 19.8455 -0.140907 -363 2 12.9154 7.83668 11.013 -6.3959 11.2287 -1.2259 -364 1 15.209 8.0796 3.38747 1.18456 -35.8933 6.76248 -365 2 14.5518 7.57266 2.91157 -10.3511 16.9608 -18.4151 -366 2 15.3784 7.42989 4.0872 14.9983 19.582 11.3682 -367 1 17.1108 6.70081 18.626 -14.4882 23.5427 -0.564853 -368 2 16.573 5.93167 0.182006 3.19594 -3.93797 2.70551 -369 2 16.4292 7.40436 18.4932 17.3888 -11.7094 -2.73385 -370 1 8.93374 7.05508 7.97597 -34.6157 -22.4872 9.48373 -371 2 9.83531 7.32727 7.97774 29.5921 7.62374 2.22252 -372 2 8.80811 6.41093 8.72029 6.54491 10.6746 -16.3243 -373 1 12.5312 0.423333 1.1911 6.44852 -9.8202 9.01884 -374 2 13.2753 0.834119 1.64897 1.63592 5.99122 -1.78887 -375 2 12.9315 0.0607692 0.396252 -6.77848 2.89528 -3.69601 -376 1 5.75537 14.98 14.4363 12.3645 2.0371 -4.21343 -377 2 4.82148 15.0687 14.6213 -16.3449 4.01416 5.01671 -378 2 6.0882 15.8478 14.162 -3.83146 3.10822 0.706071 -379 1 3.69037 6.49544 1.72037 -3.07239 6.81288 -7.41536 -380 2 3.43088 7.36249 1.36332 1.27628 -12.1507 -2.18765 -381 2 3.67848 6.67228 2.6574 4.23334 -3.71069 10.2966 -382 1 3.82256 11.2843 12.3046 -0.864415 -4.77059 0.0245619 -383 2 4.71622 11.5939 12.5181 -0.579536 5.4381 2.57712 -384 2 3.18979 11.9063 12.6819 -0.230908 7.2683 5.57723 -385 1 5.33149 3.8717 15.6726 -21.611 69.2317 6.1195 -386 2 6.02506 3.28248 15.4947 35.9646 -33.3333 -4.61122 -387 2 5.75271 4.79171 15.6869 -18.1046 -35.0984 -1.75377 -388 1 13.9893 10.0773 4.7789 22.4286 4.91544 -48.853 -389 2 14.2819 9.66907 5.58109 5.23319 -9.97863 19.9681 -390 2 14.5573 9.69868 4.0468 -17.0356 6.64649 24.2901 -391 1 7.62039 17.28 9.03644 -1.79817 -13.3385 2.54351 -392 2 6.82618 17.452 9.57294 2.68689 7.94648 -2.92213 -393 2 7.87136 18.0666 8.53956 -0.560867 8.99315 -4.02364 -394 1 4.58082 14.4709 3.89205 3.13293 1.46958 -13.0867 -395 2 4.66344 15.3386 4.31009 -0.0981131 -0.860678 2.59791 -396 2 4.56838 13.761 4.54421 -0.137719 -0.424919 8.72805 -397 1 14.11 7.4138 15.8858 20.156 9.8447 -1.08692 -398 2 14.9007 7.50898 15.3123 -12.2349 -4.78906 9.9244 -399 2 14.35 7.89712 16.7003 -4.15301 -9.39138 -6.29924 -400 1 2.88871 18.3931 1.90601 -10.0733 25.2579 5.70796 -401 2 2.56074 17.6209 1.45485 -4.97176 -8.65563 -11.6917 -402 2 2.08224 0.29716 2.10455 27.8478 -15.7521 2.2348 -403 1 8.03506 1.57584 4.43091 11.32 6.26446 5.75526 -404 2 7.34029 2.01323 3.92479 3.96785 0.109851 -4.32136 -405 2 8.88243 1.87946 4.04557 -12.5027 -7.48646 4.71123 -406 1 2.59748 14.2159 17.7933 -41.9258 1.66076 -8.0641 -407 2 1.85609 13.5734 17.9588 19.2075 16.8599 2.55802 -408 2 3.39352 13.7425 17.9784 23.6145 -16.2032 6.42715 -409 1 1.02442 1.99672 13.9281 17.4639 2.95853 -13.5386 -410 2 1.00308 1.87917 14.8709 4.63864 -6.80727 18.6653 -411 2 18.7659 2.1043 13.6716 -21.6962 3.88026 -3.66909 -412 1 4.27686 0.20187 13.9044 10.5162 4.04171 -16.044 -413 2 5.10447 18.3372 13.9403 -4.05013 6.4475 2.1433 -414 2 3.72354 18.5099 14.5979 -6.57077 -5.71295 14.511 -415 1 7.38305 1.01959 18.4815 -37.4449 7.12948 8.58409 -416 2 7.61008 0.74545 17.6036 5.58611 -6.30497 -21.5445 -417 2 6.41018 1.26146 18.4662 31.347 -10.6343 7.25927 -418 1 15.7518 18.4403 13.8831 -5.31168 6.41878 -7.08883 -419 2 14.7988 18.525 13.6912 13.3949 -2.54728 9.28792 -420 2 15.9153 18.5927 14.8217 -8.96218 -2.42265 4.9219 -421 1 10.3004 4.59906 16.2125 -26.9192 -42.5531 9.44494 -422 2 11.2318 4.75068 16.1287 26.1471 2.80018 1.93501 -423 2 10.2211 3.60629 16.3773 -0.864587 37.9812 -10.9337 -424 1 15.8848 17.7109 4.47524 -26.0192 -17.7161 -6.69824 -425 2 16.416 18.4558 4.72522 12.9982 18.1701 2.23702 -426 2 14.9575 17.9834 4.62838 14.848 -2.41832 2.25768 -427 1 6.86545 17.6577 14.0262 -6.12412 -8.41921 6.45462 -428 2 7.47866 17.6693 14.7646 2.09746 6.93436 13.8689 -429 2 7.44902 17.4838 13.2997 11.4214 -0.145135 -19.8537 -430 1 13.1703 6.41318 6.52816 -11.7529 -0.316938 -15.1514 -431 2 13.9829 6.90375 6.37155 7.88734 -3.14145 2.99861 -432 2 12.7537 6.33512 5.64174 6.34445 -4.78434 12.9923 -433 1 7.85335 2.30114 9.49646 -14.1039 1.33546 -28.6309 -434 2 7.23443 2.06415 10.1901 -3.07143 2.26257 12.1486 -435 2 7.33833 2.15664 8.66054 15.7097 0.546065 18.7565 -436 1 15.1664 14.7315 13.8676 -13.4222 3.7476 -0.777794 -437 2 14.8716 15.1233 14.7167 4.70885 -6.20173 -11.3706 -438 2 14.4912 14.9291 13.1959 7.90291 2.0321 9.20294 -439 1 9.36434 8.4507 3.85153 -5.45323 -8.44175 -9.3174 -440 2 10.195 8.80526 4.18009 6.07261 4.07641 1.89943 -441 2 9.48655 7.50041 3.73575 1.17631 -1.18483 4.07146 -442 1 17.585 13.5529 16.4533 28.0827 9.29223 -15.0932 -443 2 16.6463 13.3857 16.5308 -13.0105 5.34146 -4.98563 -444 2 17.7372 14.3421 15.8749 -12.9185 -11.1551 11.5131 -445 1 5.00344 10.4544 2.83444 15.3623 2.39709 8.30796 -446 2 5.84337 10.0047 3.04968 -12.8086 4.14038 -0.288119 -447 2 4.84487 11.029 3.60723 -3.54173 -2.25206 -8.41364 -448 1 3.64071 8.37653 9.83285 -3.63557 -2.42467 19.3481 -449 2 3.86873 9.30617 9.70655 -0.364806 7.27712 -2.43853 -450 2 3.42279 8.30417 10.789 5.82381 -0.771913 -15.5307 -451 1 16.012 6.92262 5.85834 3.10414 -0.205141 -1.95775 -452 2 16.7064 7.38617 6.35888 -2.44937 -6.94247 -7.87698 -453 2 16.3342 6.01666 5.66219 -6.01431 14.0457 5.91674 -454 1 15.3573 7.28861 8.91428 -7.73552 23.9623 -29.5509 -455 2 15.9286 7.60908 9.59449 17.6585 1.69923 20.6432 -456 2 15.3281 8.05346 8.27817 -7.4668 -29.0722 12.6462 -457 1 6.23444 12.7891 12.7562 -16.1216 7.07791 -6.67583 -458 2 7.04381 12.3675 13.028 12.7717 -9.63916 7.37694 -459 2 6.08648 13.5082 13.3891 2.20208 -1.21591 -2.77254 -460 1 12.1275 4.60499 13.1618 30.5736 27.4894 8.79026 -461 2 12.1815 4.60813 14.1323 1.45244 -2.14521 -6.91324 -462 2 11.4269 4.052 12.8891 -30.6572 -22.7655 -2.33684 -463 1 11.4418 8.05897 7.8749 4.39649 -6.11408 4.26725 -464 2 12.0054 7.38105 7.40707 -4.89778 19.9996 19.2901 -465 2 11.7913 8.23063 8.79017 -1.61454 -12.0828 -25.9053 -466 1 16.8934 10.7552 7.64898 5.958 -15.487 6.46706 -467 2 17.5218 10.034 7.45777 0.434714 4.65833 3.39608 -468 2 16.8005 11.223 6.82193 -0.787623 15.1873 -12.5781 -469 1 5.19162 18.0101 10.6182 -11.7475 -9.51575 -5.50364 -470 2 4.6689 17.2843 11.0141 12.267 13.7571 -4.22389 -471 2 4.61649 18.3258 9.88348 13.0529 -7.1725 20.3587 -472 1 7.61953 17.4141 1.49962 -5.28373 3.7131 11.8258 -473 2 8.17503 16.7132 1.19553 7.57367 -21.9054 -5.9523 -474 2 7.57614 18.0024 0.755384 -3.403 20.0604 -6.05803 -475 1 1.93154 12.9424 13.6297 4.26026 1.62766 0.165619 -476 2 1.31807 12.4855 14.2164 3.08324 -4.19991 0.575461 -477 2 2.34989 13.6289 14.1741 -4.48691 2.36366 -2.57882 -478 1 9.34851 6.7636 14.8211 -2.90069 2.43692 -15.7898 -479 2 9.659 5.88476 15.1078 3.08688 5.56829 -7.87962 -480 2 9.50722 6.89182 13.8456 0.484936 -6.74561 22.7152 -481 1 15.2631 4.37275 10.7209 -0.391742 -1.67154 5.71992 -482 2 16.1506 4.03655 10.897 1.37527 -0.677682 -8.66997 -483 2 15.1154 4.97006 11.4686 -2.24536 -2.27818 -6.11794 -484 1 11.4934 6.22632 -0.0241442 -6.06296 -11.7718 -8.66306 -485 2 11.6483 5.30933 -0.309107 4.27028 6.28431 2.83608 -486 2 10.5284 6.3165 18.5406 6.28072 6.83613 2.73886 -487 1 18.4725 11.4275 14.8977 -1.36673 1.10287 -33.3787 -488 2 18.0559 11.937 14.1605 1.63397 -11.827 9.6186 -489 2 18.3384 12.0011 15.6307 -5.5196 20.2825 24.8766 -490 1 7.17852 9.29091 7.31266 -12.1778 -5.70725 -5.55247 -491 2 6.76293 8.42612 7.50122 5.49043 12.248 4.67896 -492 2 8.1168 9.11866 7.26453 10.5183 -1.31775 0.108346 -493 1 18.3399 15.3762 12.1294 6.77425 7.85663 0.444206 -494 2 0.624383 15.5788 11.9067 -6.5428 -1.83873 1.38378 -495 2 17.7957 15.9125 11.5264 -1.63248 -5.99386 0.103645 -496 1 16.5386 4.34911 5.2503 -38.2238 -21.0357 51.9327 -497 2 16.6701 3.96728 6.16388 -6.69454 12.6485 -26.055 -498 2 17.3775 4.32019 4.85382 41.1543 5.3392 -22.1831 -499 1 17.7341 3.08223 10.7755 -2.39486 19.3144 10.8573 -500 2 18.6554 3.32717 10.9901 -9.67157 -6.39923 -2.68969 -501 2 17.7406 2.18791 10.4534 3.10102 -17.6187 -9.33289 -502 1 12.3347 18.6584 10.1394 22.1152 -18.6094 -11.1242 -503 2 11.4269 0.285024 10.28 -5.50333 15.1479 5.74269 -504 2 12.9381 0.769801 10.2484 -7.53185 0.18177 2.36971 -505 1 10.4414 9.72052 12.5804 5.49259 18.5488 2.65475 -506 2 11.2372 9.86145 13.1232 -3.33328 -5.81976 -2.33485 -507 2 10.4983 8.8205 12.2639 -0.9125 -13.8337 3.2089 -508 1 0.576047 2.60181 7.2501 -1.65995 13.3288 -12.3458 -509 2 0.268028 3.48996 7.49944 2.28387 -7.91724 -1.96879 -510 2 1.05133 2.26453 8.01425 -2.57801 -1.32252 3.73717 -511 1 0.35756 15.2681 6.96461 -6.18578 -18.242 -64.2832 -512 2 0.656709 14.9904 7.8095 9.46814 -3.47663 35.1726 -513 2 0.533918 14.474 6.37104 -3.56161 26.9089 25.8891 -514 1 17.0554 6.8805 14.912 24.4713 -1.83906 11.5387 -515 2 17.8121 7.50971 14.9246 -13.4777 -6.95308 -2.51376 -516 2 17.3666 6.12061 15.452 -8.01529 8.59931 -8.57008 -517 1 9.11821 12.4896 7.9597 -39.3936 14.7629 -4.46817 -518 2 9.45619 11.6923 7.5591 7.68398 -14.1787 -12.8233 -519 2 8.20522 12.6235 7.56541 34.2702 -5.52337 13.9854 -520 1 1.14934 1.62531 2.7512 -10.6975 -16.4856 11.3042 -521 2 0.557887 1.95566 2.07466 1.95024 15.5996 -8.59751 -522 2 1.5216 2.35039 3.25303 6.14281 9.13632 1.51194 -523 1 4.18801 15.1235 9.83797 -4.3571 13.9944 -8.49019 -524 2 4.15169 15.4364 8.91421 -7.63033 -5.74015 13.5827 -525 2 5.04261 14.6826 9.83518 3.69587 -3.91806 9.7151 -526 1 7.38616 2.29059 14.8987 -4.38475 3.80451 -15.2317 -527 2 7.23636 1.51405 14.3418 -1.55041 0.530275 6.25745 -528 2 7.45512 3.02747 14.2682 8.09838 -6.66607 2.4433 -529 1 18.2954 14.5248 2.13868 21.7335 16.5649 1.154 -530 2 0.530315 14.9412 2.32201 -13.6123 -15.8317 -3.76049 -531 2 17.7186 15.2797 1.96871 -6.10103 1.83177 1.59348 -532 1 10.0818 2.68123 12.8993 0.213282 -13.011 -16.4533 -533 2 9.9804 2.00538 12.1749 2.58274 17.6757 17.7308 -534 2 9.30115 3.24961 12.8455 -1.77409 -0.0668197 -1.90377 -535 1 2.92042 8.79199 13.1038 3.60331 12.5418 -6.85933 -536 2 3.19747 9.71233 12.8787 -2.51528 -19.5049 2.84802 -537 2 3.74925 8.3139 13.2755 -6.12566 -1.47569 1.35688 -538 1 3.2826 8.6043 3.78787 -1.06696 -30.5523 53.3514 -539 2 3.6648 9.24286 3.23576 21.5217 31.7748 -30.2126 -540 2 3.73659 8.75462 4.6619 -18.3855 -4.45548 -24.3241 -541 1 5.99503 7.23605 8.68049 -5.70462 -6.01689 -7.52618 -542 2 5.88732 6.32464 8.37432 -5.09887 -1.13221 5.21957 -543 2 5.15444 7.50455 9.08765 4.58913 -3.02319 1.70333 -544 1 14.8694 1.67632 1.824 4.95495 -3.07302 -21.4612 -545 2 14.923 2.54765 2.20438 -6.9063 6.82762 18.8127 -546 2 15.1986 1.83723 0.92353 -1.55356 -7.84532 7.79991 -547 1 8.71318 14.9586 0.633889 5.3189 4.72704 12.5337 -548 2 9.41548 15.0137 1.3229 -12.9747 -8.59069 -7.21106 -549 2 7.9574 14.4505 1.00218 9.17218 5.81258 0.251254 -550 1 15.3522 1.50057 7.22863 -1.61242 -14.2743 -3.26221 -551 2 14.7819 0.961058 6.63945 7.54361 11.5891 10.8038 -552 2 14.804 2.18796 7.6304 -1.95204 4.928 -5.75504 -553 1 4.88832 12.8638 18.4669 14.1773 6.076 10.5021 -554 2 5.16486 12.9634 0.754115 -2.57074 -3.9589 -10.7447 -555 2 5.64539 13.2163 17.9734 -6.87045 1.01425 -0.872896 -556 1 15.3658 8.71105 18.1022 0.313753 1.99863 -15.4271 -557 2 15.6825 9.25538 17.3367 -2.33671 -6.91366 23.9636 -558 2 15.2177 9.29821 0.21527 -1.89476 6.92048 -0.597105 -559 1 12.0025 3.14868 18.2874 -4.08601 9.85731 -2.22671 -560 2 12.1144 3.11564 0.603374 4.33643 -8.86024 -4.9595 -561 2 12.4653 2.40747 17.863 0.0624807 -1.52737 7.22507 -562 1 13.2135 12.7035 5.12884 9.73413 0.384952 2.90661 -563 2 13.7 11.8654 5.00774 -9.98906 4.00813 0.0328844 -564 2 13.4141 12.9701 6.04548 -3.79483 -4.91087 -6.97232 -565 1 6.18903 7.09371 0.234798 3.60985 -26.8596 -14.0682 -566 2 6.2071 8.04594 18.8061 -7.0012 19.4313 6.00448 -567 2 5.26363 6.79856 0.279731 4.49735 8.94005 5.55961 -568 1 17.7003 15.89 14.853 -18.1963 11.2058 -20.3772 -569 2 16.8346 16.3247 14.8039 6.19322 -4.54728 12.6057 -570 2 17.8435 15.7325 13.9057 13.4875 -6.37623 4.18836 -571 1 13.0834 0.870867 16.8965 -0.161813 1.3846 -1.86612 -572 2 14.0072 0.582211 16.892 1.10768 1.72224 0.871652 -573 2 12.5754 18.726 16.653 1.71204 -0.315799 1.62538 -574 1 10.8945 14.507 7.48359 31.9827 12.7774 -14.5262 -575 2 10.2535 13.8684 7.76101 -18.1255 -14.8352 9.6937 -576 2 11.748 14.0397 7.49435 -7.74827 -1.48019 1.36014 -577 1 17.7521 8.40099 2.11802 -4.68381 10.101 13.2464 -578 2 16.8759 8.32923 2.50971 -7.38706 6.94009 5.95596 -579 2 17.7532 7.67887 1.5098 2.25561 -17.6604 -22.6471 -580 1 12.5231 7.84865 2.0094 -2.30264 15.9804 1.37474 -581 2 12.1379 8.74758 1.97393 9.3167 -10.0751 -1.70323 -582 2 12.325 7.4571 1.14918 -4.66948 -5.90928 2.89896 -583 1 11.972 14.5025 10.3451 -2.96888 12.9379 -2.77484 -584 2 12.1874 14.7132 9.42348 -1.74009 -6.18971 10.5862 -585 2 11.0277 14.706 10.4449 2.87573 -2.36207 -4.30421 -586 1 6.71227 6.84952 15.5806 25.6498 -3.78319 22.6581 -587 2 7.68828 6.90632 15.3859 -23.8939 0.442938 5.1849 -588 2 6.62279 7.02219 16.5478 -0.830995 -1.23763 -22.0679 -589 1 7.92027 4.40739 13.1357 7.88731 17.7005 28.4833 -590 2 7.20639 4.70613 12.563 -5.96959 3.19417 -4.54574 -591 2 8.05118 5.13552 13.7952 -2.84521 -16.8776 -20.7331 -592 1 13.2899 12.2294 14.3537 -3.3223 6.18653 6.3482 -593 2 12.9901 11.3268 14.1873 4.87208 -4.78833 3.90165 -594 2 13.6879 12.5058 13.5223 1.91273 0.0234059 -4.06458 -595 1 14.5389 9.51264 7.32918 -7.01434 -27.1539 -11.6023 -596 2 15.2763 10.0624 7.53312 20.4851 16.6908 8.43718 -597 2 13.8132 9.80854 7.861 -14.3264 8.19434 11.2695 -598 1 12.68 16.8773 3.29092 2.11558 25.6431 -8.94229 -599 2 12.7733 17.3894 4.13219 -1.2803 -9.72294 -18.9636 -600 2 12.6793 17.5234 2.53176 -0.650571 -10.0569 23.6182 -601 1 0.970813 7.05439 17.3478 19.6691 8.71735 -9.44801 -602 2 0.0997442 7.2771 17.6294 -27.888 -7.65058 15.2547 -603 2 1.07493 7.61203 16.5711 5.30897 3.90939 -5.98442 -604 1 13.0218 4.86702 15.7977 -14.5255 -22.5737 -0.430567 -605 2 13.6652 4.12206 15.7771 -2.73243 23.3382 0.768668 -606 2 13.4898 5.70142 15.8866 10.098 7.61534 -0.732483 -607 1 2.35004 3.40025 5.07686 -12.6408 -17.529 -7.45963 -608 2 1.84891 3.15034 5.87751 4.27568 5.0167 -3.29201 -609 2 2.74325 4.26374 5.21682 1.23402 6.29722 12.7184 -610 1 8.14417 10.9001 13.7499 9.28616 -30.1931 45.6744 -611 2 7.9506 10.3552 14.611 8.46781 36.9232 -44.8577 -612 2 9.00813 10.5574 13.4404 -10.6035 2.99953 -2.14266 -613 1 13.0821 1.49083 13.2989 5.3891 9.28887 -24.1834 -614 2 13.7872 1.3627 12.5959 -25.8284 12.5052 17.3021 -615 2 12.4896 2.22352 12.9857 19.0093 -19.6589 8.86348 -616 1 6.62484 13.6674 2.02561 -2.30013 1.61314 -5.1998 -617 2 5.94206 14.1599 2.51404 7.05284 -6.38204 5.2583 -618 2 7.12137 13.1184 2.65568 -4.11309 1.61678 2.96157 -619 1 15.7857 6.33001 12.4874 9.47505 -1.37582 18.5865 -620 2 16.2809 6.76838 11.7933 3.97273 7.7159 -2.96061 -621 2 16.3586 6.41799 13.2831 -12.689 -0.09302 -8.30077 -622 1 16.7471 0.613682 9.52771 11.5447 -14.6629 17.7173 -623 2 16.7567 18.2848 9.57147 -3.7535 4.88819 4.87116 -624 2 16.43 0.840462 8.66213 -13.2327 5.78697 -22.1845 -625 1 6.19152 11.681 8.24955 3.80355 -8.99636 -2.81467 -626 2 5.36879 11.4903 8.73023 3.19436 -10.2741 -4.0588 -627 2 6.55865 10.8405 7.8788 -10.8203 9.76695 14.653 -628 1 2.78766 8.56788 0.409413 -52.7319 2.11899 -11.855 -629 2 2.08185 8.03903 18.552 32.3713 20.2249 14.5342 -630 2 2.26775 9.27739 0.866586 13.6595 -12.5773 -9.56289 -631 1 10.1003 10.2385 6.61376 -10.8952 5.58665 6.62413 -632 2 10.4921 9.47201 7.04387 8.70092 -2.05853 1.95229 -633 2 10.597 10.3787 5.79806 -1.31095 -2.00825 -0.431677 -634 1 6.84539 15.7603 6.76774 -1.32488 -8.5888 0.285168 -635 2 7.15445 16.2386 7.5582 -1.07119 -0.859265 -6.52036 -636 2 7.16186 16.249 5.99512 -0.908646 8.8198 -0.167177 -637 1 6.64088 12.8596 5.99362 6.27305 7.11444 -12.0385 -638 2 6.74407 13.8044 6.07603 1.27228 12.7365 2.69296 -639 2 6.25078 12.5941 6.82297 -5.96354 -7.18103 4.5408 -640 1 16.6867 12.5722 9.84379 -3.64815 -5.06409 7.40683 -641 2 16.7505 11.8965 9.15556 3.82735 1.49832 -4.74998 -642 2 16.8024 13.43 9.4304 0.212763 1.2752 -2.86494 -643 1 6.31521 2.74143 2.73106 -6.87016 -8.03266 -4.4066 -644 2 6.55003 3.64872 2.52358 -0.655364 10.9132 -0.0341781 -645 2 5.98199 2.35933 1.9027 -1.39596 -0.0669143 5.2552 -646 1 10.642 2.89265 3.25205 -8.44131 -1.48195 -5.66324 -647 2 10.1183 3.68518 3.4139 4.92295 3.00907 1.37692 -648 2 10.2968 2.53281 2.41595 2.77965 2.00448 3.56419 diff --git a/examples/amoeba/dump.water_box.amoeba.32 b/examples/amoeba/dump.water_box.amoeba.32 deleted file mode 100644 index 9019401850..0000000000 --- a/examples/amoeba/dump.water_box.amoeba.32 +++ /dev/null @@ -1,7227 +0,0 @@ -ITEM: TIMESTEP -0 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.67966 7.08769 17.9461 -18.0057 -16.954 4.82612 -2 2 7.80945 6.75579 18.2607 19.8034 12.4721 -7.17463 -3 2 8.72223 6.81424 17.0254 7.13784 0.0282027 3.08606 -4 1 18.5257 8.24445 6.83762 8.52147 14.2257 60.5703 -5 2 0.216892 7.89544 6.05003 12.0964 -15.6711 -53.3384 -6 2 0.444268 7.82601 7.5302 -13.3675 6.47926 -9.3119 -7 1 8.37906 18.5504 6.81463 24.6094 6.61103 -1.11969 -8 2 9.34042 0.098069 6.73406 -18.7879 -2.64022 0.747908 -9 2 7.93962 0.573676 6.26984 -2.09268 1.16699 2.67386 -10 1 6.58995 1.84432 11.7198 46.7475 -13.739 -10.5489 -11 2 5.88543 2.40231 11.9251 -37.1346 27.545 16.57 -12 2 6.18153 1.06275 11.3693 -7.36455 -17.4045 -5.52161 -13 1 7.1466 5.75358 2.33152 -53.3657 41.599 -1.38826 -14 2 6.36812 6.12603 2.86268 38.0857 -22.9036 -2.95785 -15 2 7.02502 6.29465 1.5182 16.1101 -20.4591 11.2904 -16 1 16.2164 10.1388 16.1382 -32.9296 19.8915 17.3579 -17 2 16.9509 10.2747 15.5847 32.6569 -1.09677 -20.2087 -18 2 15.8498 11.0405 16.2399 2.59134 -12.8635 2.30838 -19 1 10.6046 15.0374 2.30369 -9.45108 -28.933 -9.95229 -20 2 10.5292 14.3949 3.01849 1.67759 -0.529274 5.48943 -21 2 11.0236 15.78 2.70962 13.2591 21.3673 6.11781 -22 1 17.1624 8.24409 10.3708 10.41 5.9387 11.3227 -23 2 16.5528 8.68798 10.966 -4.81374 9.55532 3.583 -24 2 17.9421 8.82333 10.3208 -3.63548 -8.99367 -3.64514 -25 1 14.901 15.8652 16.3167 21.2892 -10.1645 16.79 -26 2 14.0225 16.1982 16.2525 -30.7371 12.6366 -7.00126 -27 2 14.9141 15.482 17.2099 1.64171 -7.21798 -3.7798 -28 1 12.1752 13.3771 0.408263 -10.449 7.39269 11.8256 -29 2 12.0579 13.8465 18.23 5.34035 -4.48355 -17.1718 -30 2 11.6217 13.8904 1.00796 2.45905 -0.157672 9.39156 -31 1 9.27358 5.34243 4.05546 -29.354 32.8373 13.3322 -32 2 8.64594 5.4665 4.83764 23.9402 -17.6274 -26.2044 -33 2 8.74177 5.68615 3.30282 4.39732 -15.4932 8.77495 -34 1 1.83016 4.27673 11.6495 -22.4867 33.9085 -11.1027 -35 2 1.70328 5.22377 11.9391 5.26663 -24.2909 -6.35354 -36 2 2.40811 3.85345 12.2597 16.6835 -12.3735 20.3319 -37 1 1.96438 6.83299 8.3731 -11.8866 6.09586 -26.8326 -38 2 2.49614 7.21578 9.0563 11.4719 0.0715494 18.6532 -39 2 1.81128 5.90585 8.57354 7.57659 -6.58781 5.32172 -40 1 5.40557 4.38899 7.93274 -5.84675 9.40812 -2.24834 -41 2 5.53738 3.43895 7.78131 -7.95286 9.95376 -0.129754 -42 2 4.75516 4.73491 7.29062 11.2407 -18.5615 7.61563 -43 1 3.23 2.92842 17.5524 1.14755 15.2746 17.0601 -44 2 3.93109 3.19827 16.9402 0.871842 10.3641 0.782189 -45 2 3.00444 3.70897 18.1497 2.9668 -26.2705 -22.3315 -46 1 7.4624 5.26283 6.13117 4.99569 4.7543 -2.87263 -47 2 8.02565 5.58849 6.88177 -21.8117 -10.641 -11.2175 -48 2 6.93508 4.45577 6.3254 15.5754 16.5621 10.3274 -49 1 9.77896 7.02384 11.9834 11.1892 -4.91774 24.9965 -50 2 10.2721 6.37256 11.5011 12.944 -11.2243 -3.64487 -51 2 9.1532 7.31587 11.3499 -25.3515 14.1302 -21.9158 -52 1 14.1167 3.54999 8.03003 -26.7224 -2.96987 -36.9282 -53 2 13.4732 4.22413 7.73132 14.0058 -9.36539 3.16858 -54 2 14.3809 3.80189 8.88487 12.5079 17.7406 36.8421 -55 1 4.82329 17.2568 4.03846 -17.1239 31.8599 -29.451 -56 2 5.49315 17.973 4.01308 -7.2715 -20.7015 10.2799 -57 2 4.18746 17.5412 3.33843 11.1391 -13.8034 10.6312 -58 1 16.4918 16.6259 10.0493 30.7319 18.7558 -40.9431 -59 2 16.1673 16.3226 10.8594 -24.9276 -14.9205 38.9888 -60 2 15.9925 16.2084 9.33562 -5.59472 -4.21747 7.16045 -61 1 1.94489 4.93323 0.49791 29.2037 9.87254 4.22328 -62 2 2.55322 5.26335 1.2053 -16.134 -9.14189 -14.6469 -63 2 2.08253 5.591 18.4408 -15.0883 -1.49688 2.64821 -64 1 11.816 13.3571 16.2711 -9.40148 3.94995 7.41554 -65 2 11.2371 12.6203 16.5671 11.2868 -0.226619 -16.3723 -66 2 12.2446 13.1893 15.4079 -8.93504 -7.51369 10.5349 -67 1 10.105 11.0651 16.9545 19.171 -30.5561 3.11717 -68 2 10.5674 10.1947 17.1295 -13.2328 27.8223 -6.21699 -69 2 9.25349 10.8067 16.5912 -4.96621 2.04172 2.74708 -70 1 11.7264 17.5421 13.4742 -3.04385 -27.7441 -11.1528 -71 2 12.2771 16.9836 12.8968 -5.80236 0.92931 5.24929 -72 2 12.1041 18.3936 13.317 3.92972 25.4072 2.69815 -73 1 6.33029 9.31911 12.2264 14.5686 -26.7823 -24.0739 -74 2 7.02603 8.96242 11.6353 -16.9594 2.64581 0.0898615 -75 2 6.81249 9.95941 12.7172 6.645 23.591 18.9185 -76 1 16.2187 12.7249 2.70186 -8.60429 -40.8729 7.98732 -77 2 17.0292 13.1566 2.50302 21.6794 20.3416 -10.6726 -78 2 15.4982 13.3357 2.61812 -11.4268 23.7847 2.88762 -79 1 0.637202 12.5625 5.84914 -31.8402 8.87564 3.58131 -80 2 0.892312 12.5507 4.90771 -4.9886 -2.92912 11.9697 -81 2 18.3039 12.804 5.85329 37.806 -5.77498 -8.15105 -82 1 5.19922 16.3781 18.5047 -8.79571 2.1563 -13.4584 -83 2 5.80284 15.8543 17.9455 2.86332 8.92403 13.1762 -84 2 5.67034 16.9636 0.462296 7.01287 -6.10758 -1.1835 -85 1 0.510145 7.62945 4.0545 45.1401 15.6351 -20.049 -86 2 18.5719 8.14656 3.45296 8.17292 -14.6601 7.70417 -87 2 1.46496 7.74082 3.66917 -48.4928 -0.554047 23.6518 -88 1 3.14672 8.89584 6.52626 -55.2927 3.32392 -1.46176 -89 2 3.50609 8.59991 7.35294 11.5609 -2.03159 9.82262 -90 2 2.14573 8.92962 6.68203 43.6989 0.357582 -10.1043 -91 1 7.30854 10.3037 16.1717 1.78466 -0.469392 13.5048 -92 2 6.56213 10.4624 15.5802 -0.177974 -0.17468 9.69093 -93 2 6.99303 10.278 17.1118 -1.93161 2.46429 -18.5659 -94 1 11.1122 1.06968 4.98939 -2.5529 -18.3754 16.0671 -95 2 11.0776 1.97142 4.64864 2.28669 -2.46607 -13.2595 -96 2 10.7048 0.433547 4.37027 3.43033 14.549 -3.59534 -97 1 4.45204 2.70061 13.2052 -5.66348 -30.5004 33.0628 -98 2 4.60333 3.05865 14.0914 -1.92534 16.2672 -14.1546 -99 2 4.38645 1.737 13.4626 -0.349226 19.9023 -23.5316 -100 1 8.42792 10.0237 1.78469 -10.3917 -19.899 15.7952 -101 2 8.3405 10.6377 2.53622 4.61332 0.207175 -2.25283 -102 2 8.49672 9.11244 2.17467 4.01989 28.7847 -10.326 -103 1 10.5335 1.75383 15.546 -34.1458 -0.453574 1.15961 -104 2 11.3977 1.82718 15.9216 24.1476 -5.37633 -0.0681618 -105 2 10.5608 1.78317 14.5837 3.50677 3.31298 -0.339701 -106 1 2.77693 12.941 7.74821 -10.4378 -0.583625 -1.53852 -107 2 3.28797 13.5733 7.23382 6.48403 3.62296 3.43855 -108 2 1.98704 12.8256 7.20013 3.29426 -8.64685 -0.0486837 -109 1 3.63517 11.6895 5.33963 -11.8109 -10.1864 -4.68879 -110 2 3.35385 11.0502 6.03137 5.66752 13.6786 -16.6554 -111 2 2.8758 11.855 4.74058 12.1084 -4.04172 11.1294 -112 1 6.88803 14.474 16.8428 -11.4129 11.5698 10.6698 -113 2 7.55973 13.8293 16.6383 5.64016 -3.74285 -2.32739 -114 2 6.60381 14.8838 16.0165 -1.10143 -9.42407 -1.70294 -115 1 14.1722 14.5374 3.41536 22.8916 -3.95473 -24.8295 -116 2 13.6514 15.2845 3.14096 -10.2906 15.0357 0.984662 -117 2 13.8512 14.2508 4.25439 -13.7068 -8.63673 17.9444 -118 1 8.28226 18.1809 16.0824 -12.751 -14.2632 -6.38017 -119 2 8.77677 17.3494 16.3071 3.86396 27.0257 -3.69586 -120 2 8.7603 0.384816 15.9919 13.8336 -15.3184 3.9152 -121 1 4.73724 1.61643 4.90111 4.42093 34.2728 -25.3552 -122 2 3.96969 2.16837 5.15263 7.5353 -10.5013 -8.47368 -123 2 5.18465 2.1484 4.15475 -16.3947 -25.6944 40.0476 -124 1 15.1457 12.8616 16.4403 -17.2871 -9.38827 44.2976 -125 2 14.6041 12.8692 17.2613 20.1997 8.40389 -10.3991 -126 2 14.49 12.6307 15.8136 -19.9308 -5.03226 -40.1466 -127 1 15.779 18.3837 16.786 46.4421 11.1965 42.4368 -128 2 16.5108 18.615 17.4688 -40.0732 -8.23978 -31.409 -129 2 15.7694 17.4186 16.7687 -10.9286 -0.13557 -0.275231 -130 1 1.1383 1.1331 16.5571 -3.78806 10.8903 6.59298 -131 2 1.96551 1.50352 16.9177 -13.4358 3.04324 -1.88802 -132 2 0.420521 1.53444 17.0916 18.9396 -8.74897 -5.5358 -133 1 18.0817 4.5907 15.863 15.5867 -18.8741 -0.0488223 -134 2 18.5818 3.91936 15.3489 -11.2031 15.1049 7.34982 -135 2 18.5602 4.7339 16.6874 -0.349245 -1.77666 -1.18458 -136 1 12.22 16.9378 16.1148 -5.50141 -11.6153 60.0453 -137 2 11.409 16.6934 16.6676 25.9686 4.83442 -31.2532 -138 2 11.9646 17.3216 15.2917 -16.184 2.10738 -25.7541 -139 1 15.8709 2.55221 17.9707 -0.937802 24.4841 -15.6355 -140 2 15.7355 3.48355 18.2574 7.57333 -26.0521 3.95198 -141 2 15.6659 2.59235 17.0072 3.66916 -5.77112 18.206 -142 1 6.70868 13.791 10.2637 2.56639 25.7323 0.00368182 -143 2 6.59347 13.548 11.1958 -0.357243 -4.92282 -5.01928 -144 2 6.58252 13.0514 9.6765 -3.72683 -17.1721 -0.802691 -145 1 10.146 18.2027 2.80372 18.7695 36.9578 -11.0057 -146 2 10.2207 0.331961 2.18345 -3.04248 -21.6078 13.7214 -147 2 9.26571 17.8868 2.67703 -19.5044 -8.44618 -8.21612 -148 1 2.97538 17.748 6.06078 -25.8303 0.797173 6.8887 -149 2 2.09399 17.6473 5.67013 0.763714 -3.05404 12.9421 -150 2 3.45883 17.8838 5.26396 31.3429 0.483929 -10.2997 -151 1 12.558 17.0134 7.97028 5.92903 -16.4499 -7.28316 -152 2 11.9572 16.2512 7.82085 0.921176 10.9238 13.6165 -153 2 12.4657 17.4524 8.83591 -10.9555 -3.32417 -4.29455 -154 1 14.8795 15.2862 8.28544 4.29768 -18.9738 42.4504 -155 2 13.9824 15.6136 8.40666 -1.92729 9.60106 -14.0248 -156 2 15.2312 15.4641 7.43118 3.9302 10.2131 -33.7787 -157 1 17.5429 18.3228 0.375372 -51.2916 -3.32975 -15.7386 -158 2 18.116 17.6308 0.128652 39.2354 -21.6017 -8.51882 -159 2 17.9698 0.288559 0.934677 25.0864 23.4945 21.3611 -160 1 0.910209 10.3712 1.41143 1.2541 -53.8465 46.4292 -161 2 0.158544 9.88347 1.87089 19.8792 18.5163 -27.3041 -162 2 0.565924 11.0969 0.944383 -23.7591 37.8535 -27.1782 -163 1 1.55407 12.175 3.31087 17.0236 24.8743 53.6813 -164 2 1.36245 11.4802 2.72234 -7.32763 -23.5838 -35.6732 -165 2 1.61623 13.0206 2.87285 0.136729 5.19924 -18.0355 -166 1 0.543127 17.2543 4.88609 31.8084 34.0538 -50.8525 -167 2 0.11032 17.9772 5.31124 -21.3387 12.8349 12.3342 -168 2 0.420366 16.4266 5.2673 -11.294 -44.4064 35.6607 -169 1 1.10053 1.01949 9.38768 20.2638 -3.47079 3.57058 -170 2 1.46081 0.575286 10.1589 5.67003 5.93636 13.5245 -171 2 0.265613 0.594128 9.34525 -28.6257 -3.15214 -10.2647 -172 1 16.8007 2.32783 13.2877 6.99662 17.0137 -29.7497 -173 2 17.0701 2.57314 12.3549 -10.9982 -8.19012 27.7721 -174 2 16.4263 1.43993 13.282 0.147057 -7.47121 1.20179 -175 1 2.45231 15.8283 12.1942 24.161 -10.1121 18.9704 -176 2 2.8623 15.5513 13.0537 -7.72007 6.59246 -26.0318 -177 2 2.91392 15.3801 11.4615 0.0476102 5.48907 2.61928 -178 1 16.435 15.531 5.9458 18.7492 36.0842 -19.2976 -179 2 17.3808 15.5177 6.20547 -11.8351 -4.55683 5.24266 -180 2 16.4147 16.2211 5.22063 -11.381 -14.928 22.2973 -181 1 5.84547 5.02056 11.8065 17.7106 -18.2202 -11.4458 -182 2 5.55799 5.91374 11.8891 -12.2572 20.16 10.1838 -183 2 5.09 4.45915 11.9819 -6.52029 -3.58907 3.63352 -184 1 15.2214 4.86555 0.731755 -13.1216 -14.4231 22.9417 -185 2 14.6776 4.45845 1.47821 22.203 16.7553 -20.5876 -186 2 14.6696 4.95834 18.5986 -12.3693 6.08689 2.65647 -187 1 16.3401 16.2933 2.11217 18.14 -13.9799 -32.9854 -188 2 16.0666 16.7695 2.87319 -13.0548 23.8975 25.5489 -189 2 16.7601 16.9279 1.50378 -12.2165 -0.858221 10.4248 -190 1 0.305885 4.87877 3.79118 -8.03527 51.7998 21.7755 -191 2 0.299338 5.85541 4.09758 -2.9952 -44.8334 -24.4202 -192 2 1.16991 4.5635 4.03062 6.79251 -10.5604 -0.715716 -193 1 2.92501 14.9782 15.0356 -0.55527 3.1583 33.427 -194 2 3.0159 14.7264 15.9987 -0.365372 -5.40078 -25.4532 -195 2 2.35392 15.7535 15.1247 4.98076 9.37108 -6.84819 -196 1 1.1115 14.5727 9.55731 53.2995 18.2393 -15.0567 -197 2 2.08491 14.4157 9.46275 -24.2978 21.5236 -5.71591 -198 2 0.897072 13.7408 9.90248 -27.8007 -35.1999 18.1171 -199 1 13.6501 16.6688 11.5433 6.47975 17.456 -8.04391 -200 2 13.4697 17.4567 10.9694 -3.73037 -22.0736 15.6897 -201 2 13.5721 15.8897 10.9842 -9.76738 -0.866763 -1.05724 -202 1 4.73098 1.47842 0.720986 0.301824 -3.12152 0.469647 -203 2 4.27169 1.98826 0.034225 -8.26683 -3.93854 8.43126 -204 2 4.11741 0.788607 1.06182 2.96071 12.6313 -1.58966 -205 1 1.42158 18.4663 11.9139 -14.1117 26.2958 -21.249 -206 2 1.21766 0.394331 12.6648 1.16138 0.455671 2.39682 -207 2 1.94844 17.765 12.2423 13.6408 -23.7742 11.0988 -208 1 11.5498 10.1018 4.11619 25.3456 17.7005 -19.3629 -209 2 11.5687 10.5955 3.24216 -3.14233 -16.3641 23.7483 -210 2 12.4899 10.1059 4.45555 -25.4417 -1.6091 -14.3563 -211 1 8.38254 12.182 3.76573 -28.852 -4.31545 3.66513 -212 2 9.25863 12.501 4.06076 -17.1001 4.9792 7.32521 -213 2 7.63736 12.4251 4.40785 39.3791 -3.23553 -14.7997 -214 1 14.3228 4.03714 3.29709 9.27375 -1.14036 13.2131 -215 2 14.8928 4.14179 4.10547 -9.51715 0.900554 -20.2647 -216 2 13.4701 4.45558 3.48891 4.64833 -1.13545 4.69814 -217 1 5.58188 1.78199 7.50513 -29.4992 -43.0538 46.7434 -218 2 5.0172 1.13958 8.12095 30.2312 35.5173 -41.7355 -219 2 5.33078 1.59122 6.59529 -0.079259 -3.9625 -11.0752 -220 1 17.9086 1.12503 4.88467 2.95857 -4.16946 -9.18468 -221 2 18.4038 1.54032 4.14207 -4.82318 -1.26447 16.1692 -222 2 17.6814 1.78344 5.55455 4.62183 1.86586 -4.7268 -223 1 6.83101 9.39303 4.49716 -16.0719 2.4093 -32.0921 -224 2 6.83675 9.57499 5.42715 5.68499 0.0447418 21.7322 -225 2 7.66807 8.99049 4.24996 11.5264 2.90932 7.40733 -226 1 2.71406 14.9654 1.962 -15.6661 -3.22344 -28.3015 -227 2 3.33343 14.7912 2.66354 12.1361 -6.91733 6.37301 -228 2 3.09502 14.6645 1.10257 -2.31521 10.6903 23.881 -229 1 17.279 12.8803 13.1283 -15.852 18.187 11.8592 -230 2 16.4044 13.2339 13.3283 -9.52452 -19.4408 0.302495 -231 2 17.6948 13.7346 13.0834 29.0619 4.95471 -11.8483 -232 1 15.0196 10.5818 1.38314 -38.2265 -36.9922 -31.977 -233 2 15.5102 11.1963 1.85791 34.2907 40.991 28.9525 -234 2 14.3351 11.0964 0.933298 3.32659 -5.3471 5.33786 -235 1 5.71789 6.95838 4.52856 0.683996 -27.8748 7.64407 -236 2 5.85266 7.87985 4.34179 3.58991 17.4746 0.820156 -237 2 6.44364 6.70841 5.13514 -10.315 -1.76088 -5.92415 -238 1 8.12142 8.26262 10.159 -0.695069 1.43108 44.445 -239 2 8.58519 8.93965 9.66877 7.60931 4.76567 -12.7632 -240 2 7.56021 7.74854 9.59836 -11.8614 -6.52029 -23.2391 -241 1 13.5311 18.2901 5.8079 -10.639 -13.2321 14.1155 -242 2 12.703 0.102298 5.56963 3.89465 4.4637 5.13268 -243 2 13.2939 17.6289 6.50758 1.00889 22.2284 -14.4481 -244 1 0.327324 2.56344 0.113251 1.70035 12.7901 -0.992224 -245 2 18.009 2.52214 18.5736 8.63965 15.9711 4.89881 -246 2 0.724331 3.48299 0.160564 -21.1536 -24.6374 0.514976 -247 1 12.6396 10.9599 9.76875 -56.8672 19.3176 -11.2335 -248 2 11.6552 10.7306 9.75031 35.1307 23.7735 -5.55284 -249 2 12.944 10.1383 10.0842 27.9729 -33.5927 10.4043 -250 1 0.789377 12.2851 11.08 11.4395 6.49483 14.2632 -251 2 18.4919 12.3017 11.2021 -18.2818 -3.30898 -6.09679 -252 2 1.09088 12.7637 11.8722 5.75277 -12.0493 -6.6955 -253 1 5.04567 7.2193 13.4912 -21.0137 -4.20407 -15.1033 -254 2 5.59899 7.84649 13.0247 8.33052 12.0635 4.31379 -255 2 5.48047 6.97898 14.3058 12.3979 0.954472 8.53674 -256 1 1.28609 6.99027 11.837 -51.8154 -68.8711 -15.2848 -257 2 0.481329 7.14037 11.2978 13.8945 0.267944 10.341 -258 2 1.71601 7.79102 11.8803 31.2664 60.1884 9.92158 -259 1 15.4442 9.46712 12.3088 17.5832 34.764 29.4487 -260 2 15.6103 10.4448 12.4444 -11.1607 -30.7672 -13.8763 -261 2 15.5582 9.10301 13.208 -6.74487 -0.409264 -16.2653 -262 1 16.6404 12.9744 5.44078 0.476019 -21.9889 6.56196 -263 2 16.2955 13.8866 5.54247 3.20084 -14.9841 -16.6056 -264 2 16.51 12.593 4.54035 -6.85686 22.0547 12.2483 -265 1 6.17495 10.0683 0.210584 -24.8048 -7.78292 -31.6597 -266 2 5.35839 10.4511 0.557392 3.36584 -0.936069 -2.46609 -267 2 6.76092 10.0813 0.943985 27.7338 0.90169 16.297 -268 1 12.3644 6.05734 4.04236 -18.3706 -38.3329 30.2118 -269 2 12.4738 6.70802 3.38308 -4.23006 32.9396 -25.2938 -270 2 11.4212 5.77124 4.03221 17.6012 8.78206 -0.800798 -271 1 0.124733 12.8266 0.203961 3.20067 -1.28022 -4.47052 -272 2 0.029974 13.5935 0.786871 -4.13202 -3.19163 0.984476 -273 2 18.185 12.9963 18.0877 7.32574 2.49628 4.77591 -274 1 3.83931 18.5785 8.61972 20.3146 -6.32916 -11.386 -275 2 3.58625 18.36 7.70531 -8.03976 -3.33875 5.01892 -276 2 3.07994 0.282626 9.06556 -19.534 7.19375 -0.404578 -277 1 7.37599 17.2741 4.45241 46.8945 31.0513 1.9622 -278 2 8.02493 17.9603 4.76808 -26.2103 -24.7083 -3.79352 -279 2 7.47725 17.3636 3.49301 -14.0292 -8.10987 6.13371 -280 1 9.20909 17.0315 12.2197 40.0448 -1.21715 18.2255 -281 2 9.48765 16.172 11.8421 -14.9023 11.2095 -3.08284 -282 2 9.99892 17.2887 12.7762 -22.6762 -6.36186 -10.9913 -283 1 13.3284 13.0292 7.94175 -54.0325 -32.963 -10.3586 -284 2 13.0533 12.253 8.47808 14.6554 7.99008 1.85075 -285 2 14.1985 13.2855 8.14946 35.8516 11.3519 14.341 -286 1 14.9871 2.94126 15.3478 14.8638 12.3357 -7.44451 -287 2 14.2243 2.52816 14.9303 4.35222 -7.49481 -2.56315 -288 2 15.7054 3.02501 14.6718 -19.1947 -5.47381 11.1555 -289 1 9.85637 15.4939 17.0026 4.34281 7.61827 -6.92944 -290 2 10.2013 14.6312 16.7411 4.19591 2.79737 -1.68983 -291 2 9.35728 15.3668 17.8085 -9.66212 -2.87408 7.84053 -292 1 11.2848 8.23994 16.5492 3.25751 34.7591 1.5155 -293 2 10.8315 7.75123 15.8747 -12.3664 -15.1549 -6.58201 -294 2 11.7506 7.62533 17.1016 5.33248 -14.8245 8.28699 -295 1 3.77097 18.1898 16.7118 4.01905 33.5947 11.0152 -296 2 4.24576 17.6768 17.3569 8.65949 -22.0954 6.28955 -297 2 3.7978 0.441972 17.1008 -4.25038 -14.6471 -12.4326 -298 1 2.20581 4.09889 8.95874 2.08991 2.93543 4.28652 -299 2 3.00197 3.55544 8.74643 -14.7124 14.9899 14.3923 -300 2 2.10364 4.24367 9.94001 10.2614 -16.6264 -23.5165 -301 1 9.9196 10.3581 9.75231 -25.3187 14.4865 -18.1673 -302 2 9.34403 11.1055 9.40387 23.5511 -18.6954 16.391 -303 2 9.87032 10.282 10.7171 2.48436 10.3271 -7.39297 -304 1 9.73405 0.807167 10.8572 20.2474 21.386 4.54274 -305 2 9.58177 18.5811 11.2204 -17.7151 -14.7389 -0.277185 -306 2 9.10878 1.03014 10.1675 -11.7891 -3.63679 -6.29284 -307 1 9.18221 15.2247 10.2123 -13.9791 -9.46207 -17.3808 -308 2 9.04674 16.0847 9.7631 0.486754 -17.6411 9.75771 -309 2 8.3908 14.6843 9.94105 18.1048 12.7648 16.7376 -310 1 1.00316 9.27987 10.329 16.2357 -30.0069 -12.307 -311 2 1.16727 10.1904 10.5724 12.5584 13.4462 -0.132091 -312 2 1.84996 8.76119 10.1498 -29.1191 35.4904 9.82697 -313 1 16.8004 4.89338 8.19813 20.3933 -12.8673 28.5682 -314 2 16.1748 5.31624 8.83318 13.8703 -8.22156 -17.3769 -315 2 17.4877 4.38941 8.71628 -28.7666 17.1718 -13.9408 -316 1 14.6379 14.6893 0.402347 -11.3933 -1.08114 12.583 -317 2 14.9609 15.3376 1.05877 1.73558 -10.8431 -5.12344 -318 2 13.9048 14.1906 0.841144 16.133 14.0369 -13.7985 -319 1 3.51181 11.0525 9.63829 3.71178 7.51059 -9.42611 -320 2 3.41507 11.3617 10.5484 4.21267 3.5616 -2.2445 -321 2 3.25155 11.8076 9.06383 -1.86739 -11.3951 3.16022 -322 1 11.0289 10.8695 1.26208 17.5529 18.9634 -6.32419 -323 2 11.1535 11.716 0.753779 -2.53448 -25.7082 13.9861 -324 2 10.1142 10.5923 1.16471 -5.76816 1.63272 -1.45278 -325 1 13.2239 7.06188 12.8977 -31.5053 10.0751 -2.41927 -326 2 14.1381 6.84046 12.8922 27.4331 -7.40558 0.979603 -327 2 12.7471 6.22139 12.9668 2.74296 5.12722 -5.48309 -328 1 9.62584 1.88878 0.937813 20.2039 -2.98483 37.6532 -329 2 8.77484 2.11506 0.623903 -27.5663 2.83673 -14.773 -330 2 10.1764 1.70882 0.191067 9.03311 -1.803 -18.3794 -331 1 10.6054 13.537 4.7508 -5.88392 -4.211 -2.61457 -332 2 11.3208 12.9359 5.04367 -2.43279 15.5075 -5.53386 -333 2 10.4128 14.1619 5.47507 10.6777 -11.2442 -5.71889 -334 1 14.2525 1.6915 10.8868 22.6682 20.2673 6.9187 -335 2 15.0842 1.26497 10.6465 -0.175006 -8.05208 -4.1062 -336 2 14.5069 2.62992 10.8824 -12.4791 -0.486299 1.09093 -337 1 14.6678 12.4248 11.7157 -13.2082 -11.6835 -6.16669 -338 2 15.5574 12.5766 11.3177 -21.8957 -10.6844 -5.73724 -339 2 14.0022 11.9667 11.1187 29.6297 15.7618 7.64488 -340 1 8.24065 5.08218 9.78509 -6.47861 44.5837 29.4664 -341 2 7.45364 5.10173 10.3836 14.047 -11.9893 -18.2698 -342 2 8.36822 4.22882 9.41503 -9.58488 -33.9934 -8.19516 -343 1 1.59893 16.8132 18.3262 1.96117 45.1636 -18.3395 -344 2 1.99225 17.1675 17.4932 -11.7114 -3.37836 17.8399 -345 2 1.72693 15.8931 18.2458 8.8364 -33.8164 2.61771 -346 1 1.43382 17.2563 15.3383 72.5903 -10.7327 -13.0674 -347 2 1.32309 18.1562 15.5759 -7.01853 28.114 11.2541 -348 2 0.623143 16.841 15.3782 -65.0193 -20.0106 1.99827 -349 1 3.73599 5.55499 6.2196 -15.153 37.171 -3.6345 -350 2 3.32092 6.26594 6.76194 -0.427016 -18.6419 -6.59332 -351 2 4.19567 6.05321 5.52665 9.16489 -2.39818 -0.177123 -352 1 12.357 9.41487 14.1826 14.7553 -23.0333 -0.513454 -353 2 12.9591 8.63784 13.9021 -31.7094 29.7183 13.6876 -354 2 11.936 9.15457 15.0346 15.6336 0.764049 -11.787 -355 1 4.0362 15.2647 6.90572 29.1452 22.7898 -8.55589 -356 2 3.45744 16.0249 6.7945 -6.03593 0.633302 -6.25525 -357 2 4.92941 15.6518 6.66696 -24.7672 -22.8121 8.07817 -358 1 0.606517 8.56128 14.8606 8.16327 11.3924 -6.42857 -359 2 0.498099 9.52604 14.9437 -1.3098 -5.53798 5.35752 -360 2 1.28855 8.50016 14.167 -7.84877 -5.15776 5.22176 -361 1 12.9763 8.3683 10.3434 -0.844759 8.90572 -31.1716 -362 2 13.7163 7.90436 9.89822 -4.62341 -2.31264 17.3373 -363 2 12.9003 8.0957 11.2534 8.39581 -13.8091 14.665 -364 1 15.2983 7.63672 3.47583 -36.1974 -22.3868 30.0346 -365 2 14.5024 7.10501 3.29647 15.8969 13.8763 -24.8874 -366 2 15.2922 7.47095 4.43335 27.1257 13.219 -1.62631 -367 1 17.3208 6.63818 0.028906 -14.8751 21.4285 -7.11338 -368 2 16.7479 6.05403 0.554933 2.23596 0.744461 -7.2242 -369 2 16.7141 7.27151 18.2009 9.57247 -21.991 17.917 -370 1 8.79355 6.92545 7.84172 -22.0329 -24.5159 21.3067 -371 2 9.63968 7.32585 7.85068 36.717 16.3192 -5.46325 -372 2 8.77688 6.39871 8.67404 -5.56167 6.19415 -17.3543 -373 1 12.3209 0.607808 1.1741 -8.60043 -0.59496 -5.94607 -374 2 12.995 1.15082 1.58835 11.0262 -7.11766 4.69751 -375 2 12.79 18.5825 0.66073 -1.01688 3.73434 3.9163 -376 1 5.68514 15.097 14.5145 8.08213 26.2607 -13.8654 -377 2 4.72797 15.1695 14.4772 -8.65505 -1.66018 8.38379 -378 2 6.02476 15.8935 14.032 -4.56821 -16.9623 16.8148 -379 1 3.822 6.53853 1.67803 10.5239 -7.29529 -10.476 -380 2 3.54968 7.33117 1.17576 -0.94291 -9.86176 19.1013 -381 2 3.81642 6.7886 2.60252 -1.1437 7.90849 5.70077 -382 1 3.89262 11.6088 12.227 12.6183 0.535598 5.61903 -383 2 4.72051 12.1032 12.348 1.21499 -6.42147 -0.654839 -384 2 3.26281 12.0921 12.7526 -15.9809 8.56892 5.74885 -385 1 5.45444 3.88172 15.8755 8.44756 62.1439 23.7417 -386 2 5.90627 3.24049 15.3708 26.1603 -31.2362 -14.1171 -387 2 6.11665 4.65725 15.9739 -35.5554 -35.0069 -5.06549 -388 1 14.4636 10.317 4.39501 5.54347 -18.2961 -43.8287 -389 2 14.9051 9.88853 5.13417 0.162303 -5.91623 3.64337 -390 2 14.7084 9.81768 3.53446 -11.8135 21.0668 42.8202 -391 1 7.94949 17.2895 9.24469 -10.6799 8.8199 -1.02562 -392 2 7.23447 17.5423 9.86969 8.35341 2.50468 -15.9799 -393 2 8.01085 17.8889 8.47627 -8.2125 1.31495 9.33291 -394 1 4.4986 14.4237 3.96317 23.4879 4.54475 27.495 -395 2 4.89523 15.3318 4.14709 -14.6852 -27.1979 0.729547 -396 2 4.80237 13.7713 4.67129 -11.1841 28.5155 -20.9146 -397 1 14.3358 7.38467 15.7635 18.2582 5.36164 1.70543 -398 2 15.2401 7.23754 15.391 -25.5283 4.5174 14.2628 -399 2 14.4998 7.83446 16.6232 -7.00614 -11.7321 -15.3353 -400 1 2.86875 18.2246 1.90934 11.7547 29.7641 47.6357 -401 2 2.54447 17.7626 1.17928 -20.4445 -34.8995 -41.4626 -402 2 2.08284 18.4154 2.45796 12.4063 3.86937 -8.17484 -403 1 7.96139 1.61197 4.52525 30.3503 -5.61589 29.1814 -404 2 7.4985 1.83317 3.72811 -5.85178 12.6793 -14.6648 -405 2 8.84188 2.051 4.57628 -22.8061 -6.44347 -10.2559 -406 1 2.69247 14.1251 17.7583 -44.9975 -8.30966 9.027 -407 2 1.78944 13.8074 18.0556 29.9332 0.951363 -12.1679 -408 2 3.33089 13.517 18.1683 -0.885538 6.08231 -6.55793 -409 1 0.711797 1.68055 13.8626 46.1903 -0.903658 -18.4125 -410 2 0.854596 1.56791 14.7929 -3.1534 -4.53792 18.4431 -411 2 18.4557 1.86826 13.7064 -36.4408 7.03813 3.66844 -412 1 4.5582 18.5986 13.9691 16.7448 -5.62304 -20.7496 -413 2 5.37614 18.0918 13.7297 -17.5024 17.6116 13.2075 -414 2 4.4096 18.4453 14.9034 -5.9637 -5.97884 8.59903 -415 1 7.10973 0.453475 18.3742 -15.9095 45.4284 35.234 -416 2 6.99644 0.098599 17.5235 1.36411 -17.312 -40.4978 -417 2 6.34312 1.05085 18.5323 11.251 -17.9428 -0.916775 -418 1 16.0934 18.4421 14.1505 -12.1616 -21.5095 -38.715 -419 2 15.444 17.7866 13.7542 19.2119 24.6311 23.4234 -420 2 16.0379 18.4915 15.109 -11.392 0.0248185 1.48898 -421 1 10.1156 4.52417 16.2956 -62.1497 -10.7811 -30.3439 -422 2 10.9808 4.34247 16.5381 55.5233 -0.530433 19.4573 -423 2 9.84863 3.69679 15.8473 1.30878 12.8229 10.5952 -424 1 15.8226 17.9425 4.41327 -8.6596 2.53656 28.4341 -425 2 16.5547 18.5732 4.53052 -7.53986 -1.28134 -1.76301 -426 2 15.1071 18.2295 5.06915 24.8326 -13.5436 -35.3744 -427 1 6.9246 17.3574 13.7412 35.4232 12.1969 -4.79491 -428 2 7.49648 17.8115 14.4369 -19.095 -19.6264 -17.6052 -429 2 7.52703 17.1963 12.9658 -8.44681 6.90552 21.4872 -430 1 13.2892 6.57209 6.73437 -47.4462 -6.01427 11.894 -431 2 14.2146 6.66317 6.83486 37.5911 0.460957 -13.6759 -432 2 13.0394 6.38579 5.82242 8.60231 0.411312 -6.48828 -433 1 7.6616 2.3861 9.17526 11.1339 -5.58665 -35.6695 -434 2 7.32169 2.39592 10.0555 -17.0215 -5.04529 20.6135 -435 2 6.95914 2.1022 8.53308 18.7558 7.43711 21.2842 -436 1 15.1464 14.8771 13.6482 -7.73724 1.21311 0.537171 -437 2 15.0308 15.0223 14.6069 -1.84691 1.26092 -11.2626 -438 2 14.3194 15.1152 13.1798 14.9291 -3.65447 11.731 -439 1 9.29105 8.34315 3.70472 21.3149 -22.535 5.81715 -440 2 10.1776 8.75859 3.73678 -10.082 3.55323 2.49013 -441 2 9.48378 7.39942 3.88081 -6.26995 14.6936 -2.40173 -442 1 17.6854 13.4687 16.4528 7.27147 30.461 -18.2669 -443 2 16.7357 13.4337 16.3398 -4.89197 -8.49248 4.47316 -444 2 17.8844 14.3284 16.0065 3.65909 -18.1112 10.9221 -445 1 5.04883 10.6547 2.58751 22.4142 -14.5409 3.1837 -446 2 5.87017 10.3468 3.04382 -22.783 5.18619 -3.79272 -447 2 4.55197 11.1441 3.22928 -6.35653 9.92745 13.9967 -448 1 3.70566 8.3683 10.3381 0.421872 -35.3081 -1.7593 -449 2 3.86061 9.29726 10.2176 3.60826 23.2513 -1.90293 -450 2 3.86652 8.14601 11.2715 -1.83662 8.64514 -7.63686 -451 1 16.1079 7.11641 6.33859 18.7251 -13.7954 -9.96454 -452 2 16.7241 7.70559 6.80408 -7.87205 -5.85527 -7.24175 -453 2 16.6678 6.33083 6.12136 -22.8952 10.0887 6.36104 -454 1 15.2027 7.00502 9.1117 -13.5711 31.2066 -33.9348 -455 2 16.009 7.42176 9.46585 -10.2898 -7.03399 -7.73296 -456 2 14.9881 7.51375 8.25647 13.8068 -20.3115 41.0185 -457 1 6.4525 13.1649 12.9201 -16.9811 1.25576 1.12717 -458 2 7.2977 12.7289 13.0561 1.55279 -4.02118 8.73008 -459 2 6.25327 13.7237 13.7059 9.12735 -9.15034 -19.1848 -460 1 12.1145 4.49786 13.0694 62.3048 41.2439 -0.723073 -461 2 12.3852 4.68406 13.9868 -14.3297 -10.0558 -0.292641 -462 2 11.3952 3.9317 13.0199 -52.2119 -35.1204 4.15665 -463 1 11.3323 8.18365 7.8522 27.7169 3.03613 12.328 -464 2 12.0901 7.73501 7.43634 -12.9205 -4.29619 -7.69129 -465 2 11.7651 8.45102 8.68662 -18.4456 -0.736999 -3.04515 -466 1 17.1666 10.776 7.42179 36.4822 -17.3878 -25.363 -467 2 17.7906 10.0723 7.08441 -17.5934 13.4566 22.3886 -468 2 17.2793 11.4524 6.73733 -15.3427 2.84073 7.18141 -469 1 5.22802 18.1471 11.05 -23.1388 -14.8798 2.48444 -470 2 4.73762 18.1049 11.901 7.4508 0.565766 -17.6495 -471 2 4.62535 17.7417 10.374 17.7336 12.8347 12.9373 -472 1 7.56653 17.6363 1.80821 4.35794 -3.26776 57.5888 -473 2 7.65741 16.7768 1.42856 9.05039 -19.6913 -22.9027 -474 2 7.35855 18.2549 1.13994 -1.37991 13.1573 -30.1972 -475 1 1.85092 12.9256 13.6076 18.7065 20.702 19.2299 -476 2 1.72104 12.4156 14.4258 -5.54537 -0.960406 -11.4426 -477 2 2.19932 13.7866 13.9501 -8.88955 -22.8153 -6.43965 -478 1 9.73868 6.79159 14.8001 -20.0718 45.6966 0.235719 -479 2 9.95236 5.95211 15.1529 12.0129 -40.6355 11.2206 -480 2 9.967 6.84408 13.8723 5.59208 -5.10263 -8.66058 -481 1 15.2087 4.3972 10.7794 -27.6923 -26.0969 -27.5028 -482 2 16.0082 3.89203 10.8637 26.1176 6.2885 5.33656 -483 2 15.2102 5.16148 11.3322 8.48984 16.211 19.3779 -484 1 11.1963 6.12482 0.150068 -21.1972 -23.7011 14.8212 -485 2 11.2381 5.20796 0.481504 11.4486 12.9471 -10.1704 -486 2 10.2374 6.21547 18.6186 14.0424 14.8346 -3.67395 -487 1 0.19533 11.3359 15.1413 -20.6703 11.3325 -28.7309 -488 2 18.4021 11.874 14.3993 9.91215 -19.3636 27.3138 -489 2 18.4481 11.661 15.9631 4.36494 9.01906 -3.16307 -490 1 7.06882 9.13032 7.26059 -19.4655 -1.24154 14.8953 -491 2 6.55985 8.40099 7.69941 12.6354 16.9737 -16.1687 -492 2 7.9725 8.82922 7.21375 8.43039 -5.65083 0.275054 -493 1 18.4578 15.4507 12.3537 3.87705 -1.0699 -4.92487 -494 2 0.776651 15.5698 12.2511 -12.7177 -2.03387 6.80581 -495 2 18.1456 15.6789 11.4721 -4.67377 -0.406651 0.743757 -496 1 16.5694 4.36967 5.25107 0.98709 -29.8421 42.9348 -497 2 16.7744 3.81151 6.06026 -19.0257 27.4778 -23.1846 -498 2 17.3898 4.32671 4.78168 15.572 7.21618 -21.1326 -499 1 17.788 3.06911 10.7078 7.64381 16.9425 17.2861 -500 2 0.075758 3.1322 11.0257 -14.4921 -2.82201 -9.29777 -501 2 17.6332 2.20749 10.3226 4.29805 -13.9207 -6.70838 -502 1 12.3142 0.064083 10.1758 -16.2036 46.6093 2.93236 -503 2 11.3746 0.384648 10.259 24.7548 -16.9496 1.0795 -504 2 12.8178 0.919304 10.3228 -10.1981 -36.9052 -8.89593 -505 1 10.3666 9.83315 12.2981 10.0643 6.74252 24.9843 -506 2 11.1015 9.85063 12.955 -7.48254 2.69098 -11.3777 -507 2 10.1328 8.91188 12.2898 -1.25875 -17.3524 -2.69444 -508 1 0.463654 2.82678 7.01839 23.1504 30.9543 10.494 -509 2 0.875324 3.58845 7.48211 -15.8261 -9.71426 -11.3384 -510 2 0.770257 2.12665 7.58365 -2.51696 -19.6875 3.88184 -511 1 0.478371 15.2358 6.91004 -5.36214 -57.1351 9.88058 -512 2 0.585298 15.6463 7.75647 2.33624 13.0536 15.0713 -513 2 0.556531 14.2524 7.18353 -2.6234 48.5984 -27.3232 -514 1 16.9534 7.00251 15.3394 -19.8576 7.98442 -8.98385 -515 2 17.6338 7.63543 15.0899 18.202 -5.57661 4.9227 -516 2 17.3093 6.19568 15.7235 12.2576 0.0838452 -6.46227 -517 1 9.0001 12.4151 8.13768 -31.7276 34.3494 27.7642 -518 2 9.37386 11.8218 7.49742 -2.69042 -17.0115 -24.8182 -519 2 8.02402 12.632 8.03373 37.271 -17.4326 -7.14384 -520 1 1.27238 1.95406 3.05803 -14.2139 -9.70678 -17.9319 -521 2 1.26084 2.61511 2.34121 0.72572 -7.36998 11.1944 -522 2 1.89031 2.22344 3.73293 7.71835 10.2015 -2.21509 -523 1 4.13907 15.1156 9.62039 -24.138 8.67184 14.727 -524 2 4.07003 15.1439 8.65747 7.76366 -2.53025 0.663124 -525 2 4.96029 14.7006 9.86457 16.019 -6.11163 -3.79055 -526 1 7.17628 2.17866 14.5671 8.05543 15.8774 -0.750343 -527 2 6.99528 1.68402 13.7698 -4.08254 -5.57585 -6.74919 -528 2 7.62131 2.98432 14.249 -3.31184 -9.11349 9.13274 -529 1 18.6082 14.7131 2.1481 32.1263 -19.3615 -2.59353 -530 2 0.838003 15.1297 2.25966 -2.55576 -5.62694 -3.02712 -531 2 17.988 15.3544 2.42675 -29.4597 23.3621 5.14018 -532 1 9.94138 2.79524 12.9422 18.0301 -20.084 -2.65944 -533 2 9.79404 2.1456 12.2228 -2.72579 10.1868 5.0837 -534 2 9.17835 3.36299 13.0326 -9.76513 7.42125 -6.32672 -535 1 2.80444 8.90955 13.0076 -21.3878 -12.6555 -0.633582 -536 2 3.06361 9.80599 12.872 11.8276 24.8177 -4.92621 -537 2 3.5122 8.48618 13.4775 16.8101 -10.8298 6.5617 -538 1 3.236 8.3574 3.63664 -3.24123 -25.7508 65.6997 -539 2 3.45085 9.0718 3.07326 14.699 31.6407 -15.7982 -540 2 3.47645 8.58669 4.60794 -10.8292 -3.55345 -46.4885 -541 1 5.62853 7.18594 8.51094 13.0444 23.9613 2.26298 -542 2 5.46784 6.31815 8.13889 -4.11832 -12.799 10.1434 -543 2 4.96415 7.47792 9.15047 -6.22666 -11.1251 -0.517113 -544 1 14.8757 1.26039 2.01768 6.89853 7.12439 -27.6668 -545 2 14.9353 2.01952 2.56559 -6.08088 15.4811 28.5729 -546 2 15.2784 1.60993 1.21235 -3.12956 -15.001 -5.59525 -547 1 8.22892 15.2012 0.850139 9.01324 -8.86779 5.43529 -548 2 9.02213 14.9338 1.33488 4.41045 13.1537 -1.08033 -549 2 7.55366 14.6663 1.27665 -10.9347 0.418265 -6.06235 -550 1 15.6387 1.34587 7.23673 -34.4855 -14.424 -6.72803 -551 2 14.9277 0.724731 6.91269 25.2779 16.6902 6.4887 -552 2 15.1173 2.1119 7.53894 8.3028 -0.775331 -5.89355 -553 1 4.90142 13.0959 18.5232 17.5611 -6.682 24.5871 -554 2 5.32755 13.082 0.76977 -9.23128 1.69535 -18.7742 -555 2 5.44764 13.7122 18.0259 4.92611 -3.73779 -6.82361 -556 1 15.3368 8.46948 18.1479 24.407 23.6523 -18.6734 -557 2 15.8061 9.12264 17.5623 -15.0725 -19.5419 9.94084 -558 2 15.3318 8.91689 0.353875 -7.67765 1.6761 7.06822 -559 1 12.0708 3.01842 18.3809 -8.57811 34.9919 -15.9288 -560 2 11.9316 2.65996 0.60646 7.37996 -15.8634 5.79137 -561 2 12.6022 2.47389 17.7995 4.55547 -17.8211 5.72515 -562 1 13.2139 12.6752 5.17768 -11.8856 9.18106 -10.9384 -563 2 13.7464 12.0348 4.69253 2.29692 -7.56952 8.05888 -564 2 13.2564 12.5123 6.11793 11.0077 -2.72782 9.02039 -565 1 6.05443 7.0356 0.031519 0.145276 -19.8641 5.27909 -566 2 5.93935 7.95118 18.5019 2.68887 36.361 -1.99394 -567 2 5.39095 6.86665 0.702638 -10.5375 -11.3291 0.555603 -568 1 17.7528 16.0276 15.0213 -26.9751 8.08167 9.65398 -569 2 16.9476 16.5457 15.105 2.62193 -2.13449 20.9775 -570 2 17.7479 16.0055 14.0813 23.0391 -15.2709 -33.7916 -571 1 13.196 0.994907 16.5363 6.64944 3.5152 15.0268 -572 2 14.1481 0.997912 16.7614 -13.0846 -5.94027 -6.50206 -573 2 12.8833 0.094199 16.7238 3.13951 3.25376 -8.62791 -574 1 11.1253 14.5647 7.20271 12.6179 20.8985 -18.374 -575 2 10.4007 14.3183 7.72981 -32.928 -10.0181 24.5345 -576 2 11.7186 13.8255 7.26943 16.9686 -3.76464 3.70387 -577 1 17.5081 8.62849 2.08107 18.4536 39.9223 21.5452 -578 2 16.6801 8.63471 2.55495 -14.8656 -12.3201 1.9096 -579 2 17.5233 7.88242 1.516 -5.44609 -31.2556 -23.2052 -580 1 12.3547 8.01168 2.02213 3.34817 7.10659 0.607451 -581 2 12.2384 8.8582 1.54611 -2.17098 -11.1853 7.9144 -582 2 11.9739 7.3152 1.48261 -5.38076 0.52639 -15.2068 -583 1 11.8761 14.6165 10.3364 1.47614 -26.5661 -12.796 -584 2 12.1004 13.7873 9.81464 -15.4397 33.1565 21.8304 -585 2 10.8993 14.6888 10.473 20.8283 -4.95583 -12.7008 -586 1 6.89524 7.05211 15.6117 0.948881 6.37495 10.6055 -587 2 7.81004 7.26536 15.3122 -15.6925 -0.985911 8.93516 -588 2 6.66676 7.54167 16.4408 13.3623 -9.35483 -24.2683 -589 1 8.00326 4.73593 13.4743 46.4542 16.9938 22.3473 -590 2 7.23337 4.7302 12.9572 -38.0428 3.58552 -28.1525 -591 2 8.40671 5.62958 13.343 -10.0413 -24.497 3.68285 -592 1 13.4128 12.1818 14.2522 -5.09814 -0.706424 13.2965 -593 2 12.9414 11.3292 14.2657 9.08717 -0.174959 -7.02282 -594 2 13.7875 12.315 13.3696 0.74786 -2.13255 -0.749325 -595 1 14.8395 9.42189 7.30548 -8.6508 -34.4179 -15.7659 -596 2 15.7087 9.765 7.42505 16.3683 18.0856 5.12693 -597 2 14.2269 10.0768 7.57319 -16.6679 19.7312 11.3719 -598 1 12.6526 17.0686 3.07252 -27.098 39.8252 10.9251 -599 2 12.8376 17.5237 3.93373 4.63929 -18.9198 -22.9156 -600 2 11.9913 17.6958 2.63477 30.4514 -31.1971 13.898 -601 1 1.15545 7.13838 17.4647 3.17244 9.59861 -23.4243 -602 2 0.330359 7.36323 17.9184 0.96629 -9.78644 0.159833 -603 2 1.05514 7.47868 16.5422 0.732192 -3.11516 17.9471 -604 1 12.7562 5.15096 15.6457 43.4314 -6.34677 13.892 -605 2 13.4512 4.55662 16.0315 -22.7809 11.2033 -14.7919 -606 2 13.2414 6.00335 15.5788 -11.6166 -6.13865 2.23982 -607 1 2.53993 3.38757 4.97618 -22.6627 40.6834 48.2045 -608 2 1.7609 3.18232 5.58922 26.9518 1.19035 -20.1247 -609 2 2.84154 4.31546 5.27885 -5.90416 -46.089 -11.2441 -610 1 8.33186 11.2983 13.4548 -26.6082 5.68838 43.1719 -611 2 8.4244 11.0562 14.4444 7.75654 0.873515 -50.9507 -612 2 8.91168 10.8786 12.8197 22.3442 -13.0535 12.4472 -613 1 12.8689 1.31514 13.3384 2.90045 58.5941 -12.9641 -614 2 13.42 1.58034 12.5659 -7.54964 -19.9936 10.3698 -615 2 12.4231 2.17844 13.5496 8.73522 -32.0886 -3.11014 -616 1 6.34008 13.7169 2.14963 -18.1698 -8.87317 18.5321 -617 2 5.63978 13.877 2.82959 15.2612 6.49493 -20.3543 -618 2 6.88351 13.0442 2.56282 10.2537 -4.17084 0.110729 -619 1 15.9206 6.61444 12.7992 -24.6515 -28.5257 0.353752 -620 2 16.3106 7.25195 12.2393 18.8127 19.5603 -18.6955 -621 2 16.4213 6.59661 13.608 8.17022 1.84551 14.3752 -622 1 16.8298 0.712824 9.59482 4.92561 -19.6459 1.56363 -623 2 16.8791 18.3713 9.72616 -6.7933 22.7031 -2.37673 -624 2 16.5452 0.8605 8.67269 -3.47063 -2.57745 5.28583 -625 1 6.14624 11.7631 8.37671 0.810232 -55.5778 6.71556 -626 2 5.32447 11.4591 8.84151 13.2611 12.3623 -11.7456 -627 2 6.64226 10.8931 8.20176 -18.8432 36.5086 0.169281 -628 1 2.88754 8.61261 0.453821 16.629 -12.4076 -25.9584 -629 2 2.45212 8.04764 18.3917 -7.9132 30.8844 23.5565 -630 2 2.34875 9.28564 0.895642 -16.9187 -4.58083 -11.1609 -631 1 10.1674 10.4623 6.50123 2.03347 0.962837 -14.0367 -632 2 10.6087 9.69731 6.89122 -0.033473 -1.16532 5.68604 -633 2 10.4694 10.4636 5.56932 -4.02396 0.831062 14.2442 -634 1 6.7142 15.6951 6.55167 21.2433 7.58031 13.0519 -635 2 7.14328 16.1838 7.27089 -7.64643 -7.38759 2.93585 -636 2 7.21237 16.006 5.79102 -10.2318 7.90387 -13.7372 -637 1 6.445 13.1807 5.57797 -4.95716 -23.6388 -1.26087 -638 2 6.7301 13.9465 6.07331 -1.77634 9.04977 6.94523 -639 2 6.09943 12.5433 6.22286 1.34041 6.33507 -0.553394 -640 1 16.8242 12.5629 9.83758 4.06472 -20.7324 4.78658 -641 2 16.9985 11.8651 9.16533 -5.27225 15.8277 3.76725 -642 2 16.5644 13.3844 9.42716 1.03985 5.07871 -11.9 -643 1 6.03738 2.95058 2.86354 -7.03855 -25.5492 -1.19629 -644 2 6.40977 3.757 2.57075 15.9289 34.7492 -4.17594 -645 2 5.57703 2.61747 2.09059 -4.9021 -9.32473 -6.53819 -646 1 10.9114 3.33767 3.30112 5.22699 -4.50477 6.26496 -647 2 10.297 4.02722 3.58926 -1.95634 -6.20434 -4.73409 -648 2 10.5127 2.84524 2.57795 -5.80356 2.60284 -4.41077 -ITEM: TIMESTEP -10 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.68613 7.08001 17.9478 -7.01358 -5.91592 2.73538 -2 2 7.77987 6.83016 18.2266 16.0785 4.58355 -9.56375 -3 2 8.81561 6.77572 17.042 -2.60158 -2.67368 4.89818 -4 1 18.5411 8.25019 6.8397 -3.31911 20.0829 53.2463 -5 2 0.132112 7.95881 5.98338 15.0803 -17.7916 -37.9407 -6 2 0.419079 7.77779 7.52768 -3.57438 0.834533 -17.4022 -7 1 8.38502 18.5543 6.8162 17.8503 9.74549 -0.663478 -8 2 9.33656 0.12202 6.71165 -15.3958 -3.25669 1.14423 -9 2 7.91896 0.595612 6.31609 0.0971505 0.0480551 2.20998 -10 1 6.59239 1.84347 11.7106 33.6248 -3.3918 -11.5419 -11 2 5.88602 2.36507 12.0365 -24.0057 14.4643 13.3031 -12 2 6.19621 1.03555 11.4016 -9.54455 -15.1367 -3.43817 -13 1 7.13469 5.75647 2.33282 -16.0707 1.2807 18.6339 -14 2 6.47472 6.10605 3.02238 22.3175 -2.25238 -34.2201 -15 2 7.09016 6.23688 1.47486 -10.0175 -2.52095 21.7818 -16 1 16.2156 10.1493 16.1334 -27.9935 4.46583 14.8083 -17 2 17.0011 10.2168 15.6173 19.2784 7.57164 -10.1711 -18 2 15.8457 11.0427 16.2776 9.29404 -6.61316 -4.9073 -19 1 10.6069 15.0238 2.30809 -6.31705 -20.7544 -7.43742 -20 2 10.5597 14.4327 3.07214 -0.102442 0.508968 4.74876 -21 2 11.0526 15.7982 2.62807 10.1844 15.1967 6.36644 -22 1 17.1594 8.2489 10.3903 7.52685 0.546464 5.9579 -23 2 16.5819 8.79937 10.9325 -0.0424193 4.91704 3.34034 -24 2 17.9857 8.74574 10.257 -6.36369 -4.03495 0.916497 -25 1 14.8922 15.8683 16.3299 23.5339 -10.8154 7.03311 -26 2 14.0097 16.1903 16.2206 -28.4756 7.26009 1.81472 -27 2 14.9055 15.3621 17.1614 -4.45807 1.9077 -0.883551 -28 1 12.1657 13.3863 0.41518 7.67499 -13.0963 13.9948 -29 2 12.1102 13.7181 18.1579 -7.06431 5.66946 -3.72811 -30 2 11.6673 13.9211 1.04936 -4.85696 8.50836 -7.81927 -31 1 9.27628 5.36844 4.05123 -34.192 4.59602 9.65195 -32 2 8.65917 5.24858 4.84371 24.3198 3.71877 -28.2857 -33 2 8.65376 5.51218 3.29446 11.8948 -3.58803 14.2972 -34 1 1.82985 4.27304 11.6494 -12.5424 24.0017 -6.14821 -35 2 1.72713 5.22025 11.9335 1.67264 -20.3932 -8.37626 -36 2 2.38183 3.84857 12.2925 10.2742 -10.1374 14.5925 -37 1 1.96666 6.8371 8.3675 -1.07206 -9.37897 -7.64517 -38 2 2.48137 7.16021 9.09528 7.6819 14.0614 11.7347 -39 2 1.91994 5.89719 8.57067 -2.65468 -6.85216 -5.3032 -40 1 5.40566 4.39875 7.93795 -15.0212 -10.7202 -17.6012 -41 2 5.47911 3.43644 7.82861 5.00513 7.47325 10.3929 -42 2 4.74947 4.60653 7.2496 8.53973 6.88839 10.8311 -43 1 3.24286 2.9209 17.5475 -3.50993 31.6723 15.8788 -44 2 3.91538 3.33593 16.9792 1.14815 -4.85754 -1.50754 -45 2 2.90196 3.68515 18.1088 4.46159 -27.603 -16.229 -46 1 7.46543 5.27113 6.11173 -0.267366 -14.8618 42.036 -47 2 7.89952 5.61794 6.92737 -2.28349 10.3868 -28.0837 -48 2 7.00366 4.5014 6.50229 0.780861 12.0869 -17.1147 -49 1 9.7753 7.01959 11.9799 12.4421 -0.327694 33.7281 -50 2 10.3285 6.37932 11.5448 5.34489 -7.46932 -11.0014 -51 2 9.14168 7.33293 11.3548 -18.5265 5.10994 -23.2436 -52 1 14.1114 3.54906 8.03925 -21.2079 2.70274 -24.764 -53 2 13.5379 4.24737 7.67406 9.42135 -8.95765 0.532077 -54 2 14.4057 3.90023 8.85862 11.8721 11.0917 26.6467 -55 1 4.80077 17.263 4.02669 -14.2573 4.92943 -10.2324 -56 2 5.55275 17.8868 4.11075 -15.7048 -9.31229 -6.31173 -57 2 4.21849 17.485 3.25536 16.798 3.03083 13.1086 -58 1 16.5008 16.6241 10.052 9.35033 0.377019 -20.0251 -59 2 16.0742 16.3966 10.8515 -13.0635 -0.25069 32.9814 -60 2 15.9476 16.1716 9.40786 2.84148 0.00630379 -7.36632 -61 1 1.95698 4.92664 0.48601 10.6785 6.17321 -0.923017 -62 2 2.54546 5.28332 1.19783 -10.1544 -3.94981 -19.1082 -63 2 1.86706 5.64777 18.4726 -0.259245 -4.73099 10.3692 -64 1 11.8035 13.3621 16.2801 -12.0315 -31.2076 -16.8087 -65 2 11.3006 12.5351 16.4295 -1.37085 13.2186 10.8936 -66 2 12.2283 13.1244 15.4353 5.36339 15.8055 8.10642 -67 1 10.1086 11.0623 16.95 16.2363 -23.6439 1.11167 -68 2 10.572 10.1938 17.105 -14.3776 22.5927 -6.24497 -69 2 9.21542 10.8357 16.6616 -0.160324 -0.0991661 2.29857 -70 1 11.7231 17.5369 13.4667 -11.0418 -25.624 2.08744 -71 2 12.2825 16.9797 12.896 1.06573 10.1819 1.6514 -72 2 12.0497 18.4302 13.3866 8.679 12.3703 -3.21063 -73 1 6.34404 9.31427 12.2267 -10.7289 -25.2447 -16.4149 -74 2 6.95388 8.98312 11.5319 -2.39052 10.1346 10.7157 -75 2 6.76108 10.0063 12.722 17.2241 14.9443 4.4156 -76 1 16.2191 12.7237 2.7003 -6.42998 -13.8373 4.3175 -77 2 16.9936 13.1939 2.44509 26.0904 7.71252 -7.79508 -78 2 15.5637 13.4111 2.72948 -20.2851 11.8065 3.04981 -79 1 0.635855 12.5646 5.86231 -29.6975 10.9384 -12.0161 -80 2 0.906184 12.4779 4.92975 2.15237 -1.21985 12.1118 -81 2 18.3245 12.8391 5.75844 29.6273 -11.2198 7.31028 -82 1 5.19222 16.3868 18.4948 24.5889 -0.529385 -6.85369 -83 2 5.88953 15.8781 18.0466 -13.534 -2.69513 -2.10794 -84 2 5.71609 16.8872 0.480999 -10.5805 4.6302 6.45748 -85 1 0.515864 7.62939 4.0653 41.0474 19.9956 -23.6294 -86 2 18.5677 8.05158 3.40199 9.2753 -7.28591 11.0746 -87 2 1.47269 7.84683 3.73678 -46.4137 -9.00167 19.6367 -88 1 3.14217 8.89553 6.52533 -39.0459 6.50689 -6.5056 -89 2 3.57285 8.63007 7.33767 0.0694837 -1.26665 5.56399 -90 2 2.14756 8.93745 6.67407 38.5311 -3.64433 -0.906695 -91 1 7.31414 10.3036 16.1763 -22.1518 3.21861 21.8391 -92 2 6.53268 10.4772 15.6415 8.43374 -0.0418936 -5.11234 -93 2 6.92709 10.2964 17.0866 13.3044 -2.27208 -10.5118 -94 1 11.1096 1.06093 5.00144 -6.80657 -2.48033 -19.8934 -95 2 11.1672 1.90146 4.5306 6.84499 7.0717 9.43568 -96 2 10.7236 0.515071 4.29558 2.64862 -9.02148 12.7331 -97 1 4.44354 2.70015 13.2121 -7.85281 -5.62302 -11.5877 -98 2 4.59136 3.20795 14.0303 0.103412 -15.4758 0.294405 -99 2 4.3686 1.71349 13.3622 2.85998 26.6352 12.1157 -100 1 8.41457 10.0307 1.78829 1.66015 -12.4273 17.1623 -101 2 8.40835 10.6665 2.53096 -1.47245 -0.417386 -5.09881 -102 2 8.60407 9.1525 2.20287 -3.10051 22.5249 -10.5265 -103 1 10.5229 1.75436 15.5533 -10.8574 -2.31 -4.36647 -104 2 11.4367 1.69676 15.8141 13.1269 -3.82494 7.61076 -105 2 10.5487 1.84704 14.5957 -9.26118 2.80358 -1.94415 -106 1 2.76968 12.9399 7.75003 -7.62511 -10.5749 7.18171 -107 2 3.32023 13.5874 7.29614 -2.30989 2.01815 -3.81018 -108 2 2.03946 12.7099 7.15165 5.79412 3.19458 -2.23462 -109 1 3.64251 11.6901 5.3273 -16.0178 -10.9709 -3.95767 -110 2 3.35804 11.041 6.0007 8.31372 10.277 -11.7948 -111 2 2.86611 11.8409 4.75105 13.6859 -0.281218 5.78901 -112 1 6.88155 14.4797 16.8524 -8.387 2.95998 -0.938339 -113 2 7.57426 13.8507 16.6622 5.60788 -2.76391 3.60002 -114 2 6.54738 14.7428 15.9834 -3.14908 -1.19839 3.78249 -115 1 14.1759 14.5423 3.40785 14.1775 -0.803279 -11.9449 -116 2 13.6583 15.316 3.2037 -5.78511 13.0134 -4.56688 -117 2 13.7723 14.1777 4.18517 -7.95121 -12.1195 11.7606 -118 1 8.26975 18.1784 16.0718 57.0984 -9.85256 5.13508 -119 2 8.90468 17.4721 16.3223 -30.0265 -6.05197 -2.08742 -120 2 8.93252 0.246004 16.0158 -21.102 13.2242 -8.22396 -121 1 4.73201 1.6168 4.90814 8.59128 29.3629 -19.7592 -122 2 3.91099 2.13549 5.04668 12.4977 -9.17326 -4.88478 -123 2 5.26431 2.14928 4.23236 -22.3039 -21.7635 28.9569 -124 1 15.1182 12.8405 16.4381 19.169 -3.61406 36.631 -125 2 14.6612 12.9963 17.2965 -1.87916 -0.605635 -21.6052 -126 2 14.5331 12.7051 15.7087 -30.2626 -2.71441 -16.8094 -127 1 15.786 18.3864 16.793 25.1295 13.8681 33.7963 -128 2 16.4578 18.6099 17.5315 -31.6416 -14.5347 -31.3905 -129 2 15.6162 17.4305 16.8164 1.02724 4.80811 3.46398 -130 1 1.14089 1.13731 16.5539 1.05247 19.7088 19.8175 -131 2 1.92337 1.60495 16.9036 -3.97271 -4.80748 -10.3705 -132 2 0.461096 1.48073 17.164 6.66439 -11.1518 -10.5802 -133 1 18.0862 4.58432 15.8734 11.1688 -12.2484 -2.69667 -134 2 18.5694 3.95442 15.2994 -8.21946 11.4291 8.6944 -135 2 18.5872 4.69164 16.6898 0.203498 -2.64567 -2.95902 -136 1 12.2303 16.9505 16.1288 -38.2728 -13.2591 26.8237 -137 2 11.3888 16.5791 16.5378 36.1694 7.82178 -3.50336 -138 2 11.9114 17.1502 15.2549 6.78701 5.10115 -22.4581 -139 1 15.8814 2.54765 17.9709 5.97775 7.55467 -0.319093 -140 2 15.7733 3.43717 18.3784 -1.8513 -17.3861 -11.5789 -141 2 15.6471 2.5946 17.0126 2.53833 6.86428 19.1803 -142 1 6.70799 13.8021 10.253 -1.58408 1.43394 8.76454 -143 2 6.59288 13.5189 11.1728 1.36627 8.87991 1.27306 -144 2 6.58321 12.9942 9.75946 1.30239 -6.02422 -13.3165 -145 1 10.1413 18.2148 2.80353 9.44086 30.3012 -19.3156 -146 2 10.2266 0.305071 2.14691 0.267733 -14.8877 14.3982 -147 2 9.27777 17.8669 2.60695 -13.096 -6.5965 0.845742 -148 1 2.97176 17.7529 6.06326 -6.30899 -0.645097 35.0899 -149 2 2.08427 17.6133 5.69483 9.57331 2.68214 -12.771 -150 2 3.63239 17.8017 5.37586 1.28926 -2.69105 -18.2517 -151 1 12.5668 16.9974 7.96757 -20.2971 -18.5655 21.3419 -152 2 11.8856 16.2971 7.95074 9.26888 3.31932 -10.856 -153 2 12.3344 17.4798 8.78306 11.437 7.92329 -7.28752 -154 1 14.8861 15.2795 8.28974 -15.7554 0.3814 10.2226 -155 2 14.0374 15.7294 8.25106 -5.80199 2.88483 11.5438 -156 2 15.1981 15.4683 7.42207 26.2963 -2.4275 -26.3232 -157 1 17.5473 18.3112 0.374559 -18.2134 -6.45531 -4.6775 -158 2 18.2634 17.761 0.12213 22.8374 -25.4457 -15.3465 -159 2 17.9951 0.303427 0.894204 5.3706 29.2695 18.8411 -160 1 0.910079 10.3754 1.4141 -19.386 -45.7403 28.0244 -161 2 0.0926857 9.86966 1.69283 27.9138 11.9581 -5.7438 -162 2 0.554372 11.07 0.90565 -10.4877 37.4892 -28.5805 -163 1 1.56425 12.1843 3.32385 10.4497 17.8757 14.7846 -164 2 1.39557 11.5297 2.67534 -6.58566 -33.3087 -13.0061 -165 2 1.62643 12.9551 2.76927 3.66066 18.4363 0.784965 -166 1 0.55148 17.2559 4.87768 14.7947 16.704 -22.83 -167 2 -0.0171494 17.9122 5.24737 -12.9669 22.3753 -0.718336 -168 2 0.416337 16.5086 5.40997 -1.38762 -39.6682 22.4532 -169 1 1.10468 1.00284 9.3945 22.843 10.0615 -6.85845 -170 2 1.39907 0.698807 10.2625 -7.65597 -6.79115 6.92044 -171 2 0.213465 0.701839 9.27091 -15.6194 -8.53979 4.03703 -172 1 16.7947 2.33154 13.2859 2.87858 8.18604 -25.1476 -173 2 17.0129 2.55787 12.3417 -6.42954 -5.0835 25.2497 -174 2 16.4749 1.41822 13.3005 0.0523867 -3.46078 1.59731 -175 1 2.46566 15.827 12.1934 26.7468 -10.5365 13.2985 -176 2 2.93451 15.5288 13.0073 -9.90545 6.65681 -19.023 -177 2 2.95128 15.4495 11.4346 -3.9234 5.36807 1.6728 -178 1 16.4371 15.5461 5.94503 -4.66267 19.6238 -8.97399 -179 2 17.3612 15.5093 6.28134 -9.63254 6.93473 -7.38316 -180 2 16.3109 16.2991 5.29174 10.2179 -16.1602 20.4085 -181 1 5.84392 5.02209 11.7979 1.85982 -4.44524 -6.98506 -182 2 5.51366 5.87933 12.041 -2.35542 15.5447 8.97079 -183 2 5.10963 4.44446 12.0068 -1.26359 -10.5886 0.396425 -184 1 15.2223 4.8645 0.724291 -23.0156 -11.391 23.7803 -185 2 14.7624 4.52384 1.55825 21.1304 12.2284 -22.5635 -186 2 14.5125 5.05103 18.7394 0.751055 2.39009 4.23042 -187 1 16.343 16.2984 2.11648 10.3227 5.9227 -27.7144 -188 2 16.0112 16.8052 2.83865 -11.2354 10.0489 28.078 -189 2 16.6417 17.0002 1.51324 -1.84363 -9.29214 0.277829 -190 1 0.300695 4.8777 3.79796 -11.7144 38.8206 3.66766 -191 2 0.319109 5.88664 3.94702 6.24107 -45.2605 -6.61048 -192 2 1.15751 4.50056 4.01017 2.49534 2.82459 2.96224 -193 1 2.92353 14.9884 15.0405 10.7548 -7.33568 16.7257 -194 2 2.98085 14.609 15.9661 -8.47597 15.0336 -19.5599 -195 2 2.47925 15.8529 15.1074 -0.728265 -0.613609 8.13891 -196 1 1.11951 14.5697 9.5576 17.0302 46.4745 -20.2694 -197 2 2.08903 14.5584 9.38425 -20.4257 -12.3501 8.75388 -198 2 0.805573 13.7616 9.91809 5.52927 -28.6811 10.8766 -199 1 13.6617 16.6633 11.5459 -10.7506 10.3565 -21.4971 -200 2 13.3218 17.4276 11.0158 5.92664 -14.8533 17.3679 -201 2 13.3915 15.8986 11.0154 -3.11899 -0.859159 7.39997 -202 1 4.73366 1.47986 0.719369 -25.3145 -4.02421 3.51446 -203 2 4.15092 1.98399 0.125941 8.58395 1.79335 0.854136 -204 2 4.09918 0.853913 1.13528 12.7275 2.9151 -0.0185569 -205 1 1.42442 18.4742 11.9045 -6.93945 20.4545 -13.991 -206 2 1.2372 0.390371 12.6666 -0.822965 2.19478 3.53324 -207 2 1.89543 17.725 12.2367 7.95706 -17.4489 5.30436 -208 1 11.5469 10.1058 4.11116 26.1716 14.4711 -26.2735 -209 2 11.5284 10.5631 3.21886 -3.69376 -13.1884 23.9867 -210 2 12.5118 10.0773 4.36205 -26.1062 -0.534026 -7.20275 -211 1 8.37237 12.1712 3.75254 -13.3709 24.5961 46.1376 -212 2 9.17249 12.5936 4.11701 3.41223 -8.92861 -19.033 -213 2 7.75234 12.4533 4.48752 5.20668 -18.7884 -32.053 -214 1 14.3233 4.03204 3.29282 11.0049 6.10018 19.4579 -215 2 14.9517 4.19348 4.04461 -8.72763 -4.53117 -18.7735 -216 2 13.4979 4.46304 3.56838 3.12416 -1.49393 -3.31976 -217 1 5.58139 1.77074 7.50691 -36.613 -47.7339 30.604 -218 2 4.96189 1.1025 8.02564 35.7201 38.4984 -27.3817 -219 2 5.38779 1.57566 6.57729 1.13697 3.96791 -6.02851 -220 1 17.9042 1.1171 4.88471 6.84957 17.1887 -7.45832 -221 2 18.4571 1.56865 4.21188 -4.6905 -14.0516 5.22121 -222 2 17.737 1.81424 5.53024 -1.96776 -6.02251 3.4729 -223 1 6.82733 9.39684 4.48845 1.87187 -0.890058 -10.0607 -224 2 6.84716 9.53076 5.42818 -7.08772 5.76802 18.8049 -225 2 7.72364 9.08838 4.32443 4.93667 -1.85919 -9.57362 -226 1 2.70107 14.964 1.9632 9.79064 -8.50271 -23.1477 -227 2 3.33865 14.7342 2.63816 0.0868029 -0.794049 11.9475 -228 2 3.17782 14.7454 1.13419 -13.4 8.87294 12.5953 -229 1 17.2782 12.8964 13.1387 8.1593 -36.3772 6.82198 -230 2 16.3556 13.1177 13.3173 4.03584 18.7537 -2.31465 -231 2 17.8303 13.6552 12.9439 -8.38561 20.0322 -1.78655 -232 1 15.018 10.5797 1.38541 -30.6488 -33.8734 -22.7761 -233 2 15.5405 11.2097 1.82354 25.6355 33.1541 21.1587 -234 2 14.2986 11.0703 0.97193 1.92599 -0.723232 4.24038 -235 1 5.71261 6.94641 4.5266 2.6516 -23.4686 10.5302 -236 2 5.87991 7.88124 4.41392 4.1014 10.4162 -0.896017 -237 2 6.40034 6.62744 5.14459 -6.91809 0.316355 -6.72793 -238 1 8.10894 8.26231 10.1757 -1.61977 4.99166 17.0229 -239 2 8.63366 8.87039 9.65704 12.8257 12.1371 2.09156 -240 2 7.5873 7.82886 9.51802 -16.026 -14.2044 -11.4362 -241 1 13.5265 18.2929 5.80397 -22.7677 -1.43199 15.791 -242 2 12.744 0.210577 5.63003 6.52185 -0.137688 -2.34328 -243 2 13.224 17.7307 6.55929 8.82644 11.7072 -16.2211 -244 1 0.31998 2.55606 0.111337 -23.7151 48.4906 1.53453 -245 2 18.006 2.70756 18.6319 7.21623 -15.3908 0.76394 -246 2 0.639493 3.49242 0.214062 7.71863 -30.3236 1.31164 -247 1 12.6438 10.9651 9.76843 -27.6007 42.776 -15.0826 -248 2 11.6462 10.8587 9.68427 36.5826 -6.8361 3.61513 -249 2 13.0097 10.1328 10.024 -0.792921 -29.0746 6.76076 -250 1 0.78357 12.2825 11.0843 20.7577 -6.91251 -2.74458 -251 2 18.4749 12.2741 11.1385 -12.0685 2.84404 7.0736 -252 2 1.15918 12.6384 11.9096 -11.1326 -3.84191 -3.75479 -253 1 5.04379 7.22322 13.4829 1.39832 5.89977 -6.97466 -254 2 5.58123 7.93479 13.1271 0.448534 7.96016 -10.0051 -255 2 5.53384 7.00565 14.2746 1.03136 -7.66768 11.7435 -256 1 1.27874 6.97532 11.834 -32.074 -43.2189 -14.0481 -257 2 0.482678 7.18669 11.3131 10.1443 0.561183 6.98996 -258 2 1.70367 7.78255 12.0103 18.1825 36.8435 9.31001 -259 1 15.4541 9.47267 12.3132 5.88964 23.7827 6.22024 -260 2 15.5166 10.4677 12.3686 -5.40153 -30.7713 4.20372 -261 2 15.4815 9.07432 13.2056 -1.6395 12.2138 -11.1334 -262 1 16.6425 12.9485 5.45228 -24.7761 13.2233 -32.5849 -263 2 16.3124 13.8685 5.42836 11.1894 -7.98651 20.9726 -264 2 16.4187 12.7313 4.52305 11.1313 -16.3356 15.5726 -265 1 6.1733 10.0557 0.193027 -12.4899 -11.5053 -32.3049 -266 2 5.38495 10.4604 0.58061 6.43577 -0.470902 4.897 -267 2 6.88008 10.1049 0.827544 12.5305 3.42311 14.2724 -268 1 12.3659 6.05415 4.04188 -22.1763 -21.8278 15.5685 -269 2 12.3683 6.79715 3.46108 4.13216 24.0909 -16.7914 -270 2 11.421 5.79287 4.05326 15.4186 -0.211849 3.77561 -271 1 0.132582 12.8231 0.203992 -0.195483 1.63508 -4.90635 -272 2 -0.0245094 13.5503 0.825031 2.49545 -1.98409 0.771993 -273 2 18.2458 13.055 18.0666 5.13636 -1.5464 3.82803 -274 1 3.83888 18.5816 8.61379 -9.81831 -4.88162 -16.6552 -275 2 3.52001 18.2631 7.75085 8.43173 -4.7192 1.01067 -276 2 3.03206 0.305129 8.96677 -7.80256 7.43459 9.99927 -277 1 7.39556 17.2738 4.45596 16.9172 12.0122 12.5371 -278 2 7.99849 17.9848 4.79149 -15.6229 -16.9846 -19.2965 -279 2 7.33818 17.3251 3.48629 6.36463 5.57381 8.87833 -280 1 9.21998 17.0388 12.2284 15.8258 3.83046 11.207 -281 2 9.35195 16.1931 11.7423 2.16771 12.8413 7.7779 -282 2 10.0104 17.2216 12.8137 -16.5375 -11.854 -19.0408 -283 1 13.3184 13.0063 7.94019 -19.3301 -32.807 5.85066 -284 2 13.1883 12.2647 8.56801 -4.60418 3.91603 -7.64254 -285 2 14.1459 13.3708 8.19821 21.3317 21.1541 5.11013 -286 1 14.9844 2.95035 15.3504 8.07249 -1.73557 -24.8008 -287 2 14.3 2.40675 14.9389 -0.805511 -1.63288 7.60525 -288 2 15.6705 2.98762 14.6436 -9.05507 2.69068 16.8604 -289 1 9.85476 15.5033 17.004 5.70996 8.22456 -10.0233 -290 2 10.2769 14.6753 16.7296 0.407564 1.12786 2.5917 -291 2 9.2992 15.3275 17.7693 -4.49302 -4.18434 5.79618 -292 1 11.2887 8.25054 16.5462 4.3815 15.8935 1.4126 -293 2 10.7498 7.72178 15.9677 -11.4268 -3.01506 -11.0903 -294 2 11.7109 7.60541 17.1026 7.03572 -6.39426 11.2088 -295 1 3.78312 18.1923 16.7229 -8.20319 16.8802 -14.09 -296 2 4.23544 17.5706 17.2928 8.99584 -2.65396 14.876 -297 2 3.78517 0.451969 17.0887 5.65759 -16.2586 2.71634 -298 1 2.1977 4.10819 8.95021 24.5715 -13.8141 31.6135 -299 2 3.03624 3.61916 8.82088 -15.7399 12.2693 -11.2697 -300 2 2.14197 4.07166 9.94067 -11.3718 7.67499 -23.2123 -301 1 9.90974 10.3516 9.73776 -22.8793 37.5197 3.40937 -302 2 9.44348 11.1923 9.4561 16.1923 -27.4723 -0.755713 -303 2 9.93951 10.4177 10.7077 4.76489 -7.47333 -8.73237 -304 1 9.73601 0.810068 10.8572 -6.50885 -0.835519 -1.39877 -305 2 9.40585 18.6129 11.1735 2.22486 -11.7661 13.7712 -306 2 9.0915 1.01857 10.1847 -1.93261 14.5334 -11.6688 -307 1 9.19364 15.2092 10.2107 -23.0073 -10.2994 -8.74256 -308 2 8.9841 16.0542 9.76587 1.98806 -14.8547 5.4661 -309 2 8.35152 14.6762 10.1166 22.3916 12.2872 5.93767 -310 1 0.995532 9.29186 10.3281 47.9462 -2.63812 -8.64675 -311 2 1.22741 10.2031 10.5086 -13.3799 15.5027 2.96196 -312 2 1.9063 8.9262 10.1621 -35.7029 0.949407 3.82346 -313 1 16.813 4.88766 8.1932 11.5161 -10.5322 32.9144 -314 2 16.1615 5.34773 8.77307 11.8935 -6.11126 -18.0819 -315 2 17.4051 4.37395 8.80041 -19.6267 13.8505 -17.9411 -316 1 14.6429 14.6942 0.394535 -7.00543 -1.89626 8.24203 -317 2 15.0463 15.2494 1.09531 -2.64327 -9.316 -7.76003 -318 2 13.8679 14.2346 0.794348 15.878 11.3494 -8.58286 -319 1 3.51953 11.0524 9.63262 1.11689 7.20138 -8.56155 -320 2 3.49309 11.4422 10.5196 2.01858 0.130954 -3.30783 -321 2 3.17116 11.7397 9.0203 2.67149 -7.88535 6.47818 -322 1 11.039 10.8616 1.27104 8.39953 16.0658 -8.46941 -323 2 11.1885 11.6907 0.750788 0.782166 -19.893 14.3131 -324 2 10.1072 10.6419 1.14889 -0.773464 -1.49716 1.06219 -325 1 13.2204 7.07184 12.8933 -24.0174 5.01566 -6.09093 -326 2 14.1394 6.83939 12.9167 20.0602 -3.76028 0.39046 -327 2 12.7464 6.22555 12.8749 2.49778 2.97258 -0.29329 -328 1 9.62856 1.88969 0.946546 9.2636 -0.931103 20.1878 -329 2 8.76541 2.02695 0.593353 -22.3319 -0.80038 -4.92587 -330 2 10.1675 1.74594 0.181071 13.2226 0.132969 -11.6901 -331 1 10.5934 13.5316 4.73807 16.1446 0.574492 13.3086 -332 2 11.4317 13.0614 4.94174 -10.7106 3.3069 -14.0299 -333 2 10.5321 14.1207 5.51129 -4.24994 -4.20037 -10.3127 -334 1 14.2715 1.70318 10.8964 -1.77809 5.91235 7.28652 -335 2 15.0728 1.25501 10.5853 5.24738 9.35157 -1.74174 -336 2 14.4034 2.67095 10.8772 7.32957 -6.49183 -2.39775 -337 1 14.6603 12.4192 11.7243 1.91159 -25.2344 -56.6412 -338 2 15.4845 12.4874 11.1931 -4.23005 7.1619 22.5795 -339 2 14.0903 12.0081 11.0211 -1.48986 11.1607 31.5891 -340 1 8.24886 5.08654 9.79134 -29.2123 3.64284 23.7692 -341 2 7.42109 5.02927 10.3149 15.0309 17.1198 -4.03621 -342 2 8.23121 4.21184 9.43797 12.1669 -22.8524 -17.3047 -343 1 1.59528 16.8201 18.3251 -4.66834 32.7155 -7.23976 -344 2 1.93304 17.2062 17.488 -5.12416 -8.69561 13.5025 -345 2 1.82608 15.9028 18.3034 8.21551 -19.1337 -3.40609 -346 1 1.44054 17.2474 15.3375 38.2305 -7.16391 -6.50211 -347 2 1.35107 18.1379 15.6308 4.79859 24.8425 9.12518 -348 2 0.562777 16.9452 15.3387 -39.5261 -18.284 -3.02502 -349 1 3.72855 5.57524 6.20331 -9.94128 10.6794 2.05156 -350 2 3.21297 6.20603 6.76334 9.83918 -6.42931 -13.7589 -351 2 4.29894 6.06824 5.5848 -3.89827 7.08279 4.15512 -352 1 12.3545 9.42683 14.1827 20.4014 -41.9092 8.4814 -353 2 12.8623 8.59837 13.88 -21.4785 35.8512 3.66034 -354 2 12.0611 9.1345 15.077 2.36507 11.6403 -12.9904 -355 1 4.03327 15.2744 6.905 24.5442 3.45717 -5.69457 -356 2 3.46314 16.0225 6.67296 5.01039 2.15408 -3.12402 -357 2 4.97164 15.5268 6.67147 -27.9532 -4.4537 7.17357 -358 1 0.606997 8.56433 14.8637 1.00605 -0.185347 4.59471 -359 2 0.51054 9.52697 15.0006 4.18475 -5.95105 -3.81642 -360 2 1.25745 8.45601 14.1476 -5.10421 5.72757 5.73964 -361 1 12.9756 8.36618 10.3398 20.3701 -17.1189 -10.5242 -362 2 13.727 7.8435 10.0036 -6.14808 8.99881 -11.6124 -363 2 12.9675 8.02293 11.2263 -11.3517 2.56625 21.5008 -364 1 15.2884 7.63693 3.49378 10.1588 18.7913 -12.1111 -365 2 14.5458 7.1482 3.08376 7.93209 -0.245397 21.6039 -366 2 15.5211 7.50792 4.43838 -15.1505 -14.5868 -6.72816 -367 1 17.3202 6.64717 0.0328861 -29.9623 13.6257 -2.83905 -368 2 16.7745 5.97673 0.482414 9.93705 -0.647346 -3.81794 -369 2 16.6178 7.22121 18.2734 18.8696 -9.84661 9.86066 -370 1 8.80495 6.92785 7.84504 -31.0915 -18.6038 9.28479 -371 2 9.6769 7.2872 7.80779 30.3288 7.87046 2.96903 -372 2 8.72406 6.35246 8.64105 6.6093 9.83872 -10.9319 -373 1 12.3211 0.614363 1.17365 13.0662 -3.77868 -0.487657 -374 2 13.0766 0.983141 1.64654 -0.239842 1.32967 3.5541 -375 2 12.751 18.5673 0.657414 -10.2946 0.778432 -2.83622 -376 1 5.67951 15.1028 14.5131 10.9467 16.6442 -3.65569 -377 2 4.71936 15.1727 14.6088 -3.18386 3.297 0.861488 -378 2 6.03308 15.9436 14.1233 -11.409 -15.106 9.73801 -379 1 3.83531 6.52602 1.68735 -5.34791 11.2881 1.09554 -380 2 3.46655 7.33088 1.27913 5.03876 -12.3281 -3.02901 -381 2 3.83759 6.80671 2.60341 5.67562 -6.55284 8.9174 -382 1 3.89065 11.6139 12.2421 9.17745 -10.34 -2.42323 -383 2 4.7546 12.041 12.3761 -4.43478 1.7756 4.32079 -384 2 3.22616 12.1252 12.7041 -4.55935 10.4369 8.15325 -385 1 5.44913 3.8771 15.872 6.89679 52.3696 13.3559 -386 2 6.00532 3.19945 15.5174 15.3476 -19.3003 -7.67953 -387 2 6.04432 4.69577 15.9682 -27.8341 -34.2187 -5.04159 -388 1 14.46 10.319 4.39654 9.99722 -28.3378 -34.0856 -389 2 14.8446 9.82936 5.13517 -3.65574 0.244774 4.37558 -390 2 14.7053 9.78242 3.56924 -11.9433 24.8074 33.8136 -391 1 7.944 17.2975 9.23787 -28.0002 30.4191 -3.50914 -392 2 7.19679 17.6006 9.79194 10.1387 -11.5361 -1.79961 -393 2 7.93806 17.9436 8.50883 9.12371 -8.84918 -0.989999 -394 1 4.50274 14.4265 3.96251 25.8442 16.5744 44.5421 -395 2 4.82189 15.3364 4.24204 -15.9069 -22.6382 -13.9696 -396 2 4.78076 13.8411 4.72747 -13.1976 12.376 -28.3375 -397 1 14.3227 7.38582 15.7589 14.6846 6.74467 9.8564 -398 2 15.2487 7.24382 15.4614 -20.8339 3.06086 7.28672 -399 2 14.432 7.78597 16.648 -5.3607 -7.66211 -14.83 -400 1 2.87305 18.2228 1.9038 16.9424 31.4889 37.3817 -401 2 2.5254 17.6641 1.24513 -20.0746 -27.9737 -30.7942 -402 2 2.12041 18.5329 2.44243 8.04928 -1.15784 -8.26421 -403 1 7.96513 1.6038 4.534 28.375 12.0389 1.8382 -404 2 7.4881 1.94169 3.78174 -16.4915 0.831655 -6.1583 -405 2 8.81315 2.08427 4.47067 -11.0504 -12.9149 7.37414 -406 1 2.66628 14.1304 17.7551 -36.5802 -20.3813 5.76686 -407 2 1.82799 13.6385 18.0009 26.1666 13.51 -7.41699 -408 2 3.38829 13.5766 18.1016 -3.21353 7.84202 -3.40779 -409 1 0.72398 1.68558 13.861 19.6061 1.62564 -3.20216 -410 2 0.832024 1.51571 14.7895 8.81281 -5.19825 13.648 -411 2 18.448 1.87896 13.7961 -22.7247 6.41229 -8.76432 -412 1 4.5528 18.6039 13.9643 16.282 -5.93943 -10.6264 -413 2 5.43228 18.1791 13.8337 -18.6035 11.3559 2.42201 -414 2 4.30609 18.3878 14.8696 -5.35687 -0.29015 4.72759 -415 1 7.10471 0.475722 18.3652 -9.95344 30.3778 33.8159 -416 2 7.09526 0.10374 17.5021 -2.11792 -9.18089 -28.9852 -417 2 6.24907 0.928295 18.5508 11.5399 -12.8337 -6.73806 -418 1 16.1003 18.4419 14.1295 -36.1288 -26.1963 -8.72431 -419 2 15.3858 17.8107 13.8537 25.0074 20.4613 -2.43664 -420 2 15.9155 18.5409 15.0697 10.6475 8.10349 1.05551 -421 1 10.1087 4.51964 16.2872 -49.6317 2.46368 -20.184 -422 2 10.9899 4.47274 16.5903 35.3659 -6.27505 9.52333 -423 2 9.84839 3.65208 15.9265 12.032 5.89647 9.33422 -424 1 15.84 17.9245 4.41355 -16.3771 8.07859 19.8211 -425 2 16.4973 18.6399 4.5293 -6.75294 -6.64677 -2.2152 -426 2 15.0245 18.216 4.92863 29.2279 -12.5546 -21.8691 -427 1 6.93052 17.3604 13.733 43.7573 11.6301 8.94285 -428 2 7.46287 17.7112 14.5144 -20.3873 -12.0805 -21.5216 -429 2 7.61723 17.2481 13.0216 -16.2109 2.19972 16.1164 -430 1 13.284 6.56612 6.73549 -17.3988 -10.9235 -13.9284 -431 2 14.2147 6.66272 6.66556 31.8926 9.42178 10.838 -432 2 13.0817 6.39483 5.81333 -16.4457 -2.73061 -4.18006 -433 1 7.68008 2.38704 9.18412 -10.173 -8.0052 -21.8631 -434 2 7.24249 2.31281 10.0234 -2.88588 -0.126179 20.3224 -435 2 6.98126 2.1061 8.54708 21.029 6.80491 7.05088 -436 1 15.1532 14.8723 13.6487 -17.4978 4.30428 5.82091 -437 2 15.0143 15.0659 14.5909 6.59258 -1.67926 -7.31154 -438 2 14.3234 15.1254 13.2077 14.4343 -4.04757 1.78875 -439 1 9.30028 8.33456 3.70705 10.2977 -8.98362 5.75949 -440 2 10.1463 8.82212 3.80538 -6.03443 -8.47657 3.00821 -441 2 9.47356 7.38745 3.89392 -0.00834887 14.0135 -2.32863 -442 1 17.6906 13.477 16.4461 19.9282 13.2905 -5.82842 -443 2 16.7369 13.3711 16.3792 -1.87427 5.41308 -4.03884 -444 2 17.9311 14.3351 16.016 -12.453 -14.9372 6.18952 -445 1 5.04349 10.6567 2.59903 16.1191 -13.6813 18.2195 -446 2 5.79495 10.2927 3.12129 -13.5181 3.52014 -12.0414 -447 2 4.57705 11.1773 3.24438 -8.0447 10.2459 5.04269 -448 1 3.70971 8.35842 10.3252 1.44092 -18.6834 3.58878 -449 2 3.85247 9.29033 10.1825 3.16815 17.7869 -8.4001 -450 2 3.85129 8.23256 11.2753 -2.11366 -0.888936 -6.9574 -451 1 16.1019 7.11228 6.32302 5.1556 -18.0856 -12.5793 -452 2 16.7603 7.67894 6.76117 -3.13697 -10.0137 -6.06994 -453 2 16.5199 6.22503 6.17941 -9.70023 19.4355 5.8489 -454 1 15.1873 7.00993 9.1119 -0.598311 32.9952 -33.7165 -455 2 16.0219 7.38603 9.44635 -11.3494 -6.74009 0.758637 -456 2 15.0255 7.54922 8.27157 3.37955 -23.1281 33.9738 -457 1 6.44391 13.1496 12.9059 -4.52757 0.45998 7.29234 -458 2 7.24313 12.6736 13.1625 -0.99472 -4.48021 -2.73775 -459 2 6.29798 13.7908 13.6311 -2.25413 -7.45453 -16.6836 -460 1 12.1229 4.49714 13.069 31.9377 20.6864 19.2416 -461 2 12.2438 4.59516 14.0263 7.18846 6.47209 -3.71556 -462 2 11.355 3.98337 13.0276 -40.2556 -25.9573 -14.351 -463 1 11.341 8.18871 7.85243 -8.78275 4.89867 3.16356 -464 2 12.019 7.65272 7.40248 3.56578 3.50389 11.6767 -465 2 11.6495 8.4222 8.75253 4.0122 -9.00416 -11.7002 -466 1 17.1801 10.777 7.4192 7.36201 -8.80257 6.42916 -467 2 17.8272 10.0453 7.20283 -14.4353 25.3005 -3.23105 -468 2 17.1099 11.4706 6.73084 6.53972 -12.3853 -1.04707 -469 1 5.23123 18.1422 11.0533 -19.2518 -11.1169 -0.556795 -470 2 4.68428 18.0818 11.8689 9.03658 -0.237539 -15.4649 -471 2 4.66385 17.8138 10.3113 13.0077 11.3369 14.9543 -472 1 7.56693 17.6215 1.82415 1.62007 -3.46367 5.28784 -473 2 7.78898 16.8334 1.34681 6.63524 -26.0188 -1.32905 -474 2 7.45125 18.2129 1.09256 -3.64481 20.3372 -5.96154 -475 1 1.86389 12.9287 13.6093 11.2123 10.389 11.461 -476 2 1.60858 12.3493 14.3514 0.368407 5.87334 -8.62616 -477 2 2.19533 13.7617 14.0254 -8.04715 -19.4049 -4.74077 -478 1 9.73211 6.79545 14.8053 -13.3635 29.1677 -1.2594 -479 2 9.95388 5.9401 15.1198 6.74212 -35.5267 16.6171 -480 2 9.99758 6.80472 13.8879 2.87601 5.55808 -10.3757 -481 1 15.2079 4.3816 10.7747 2.87683 -10.6846 -6.34453 -482 2 16.1141 4.09829 10.8354 14.0041 -14.4682 -8.99775 -483 2 15.2413 5.10857 11.3759 -13.982 19.572 13.657 -484 1 11.1943 6.12299 0.161942 7.30858 3.38886 3.78771 -485 2 11.3169 5.17116 0.363074 -11.79 12.5462 -9.55941 -486 2 10.2709 6.35961 18.5708 8.1781 -12.6509 6.67443 -487 1 0.185288 11.3311 15.1365 -30.887 25.32 -22.6423 -488 2 18.3259 11.8316 14.411 15.9364 -20.9841 19.9458 -489 2 18.5436 11.8171 15.9275 6.31494 -1.3813 -2.75882 -490 1 7.07253 9.14554 7.26503 -12.8693 -9.44748 7.54332 -491 2 6.53496 8.39024 7.60511 8.01051 18.2562 -7.56901 -492 2 7.96025 8.78683 7.22728 5.66006 -0.214789 -0.295522 -493 1 18.4466 15.4455 12.3524 0.715601 -5.5542 4.25712 -494 2 0.765537 15.5739 12.2932 -9.35503 -1.07101 -3.81958 -495 2 18.1041 15.6865 11.4834 1.82716 1.84183 -0.0676895 -496 1 16.5728 4.36435 5.2485 -25.4993 -8.29978 29.4912 -497 2 16.6816 3.92322 6.14286 5.98391 16.1522 -30.7717 -498 2 17.375 4.39451 4.72672 17.8313 -3.46111 1.89189 -499 1 17.7791 3.0704 10.7152 16.7916 7.15275 7.98838 -500 2 0.0816242 3.14072 10.966 -13.8603 5.05813 -1.71981 -501 2 17.7027 2.20602 10.3066 -7.17166 -8.4112 -5.21368 -502 1 12.3075 0.0618611 10.1685 -8.15907 17.9474 -0.312818 -503 2 11.3684 0.344551 10.3468 27.9971 -1.27027 -0.956139 -504 2 12.8942 0.865557 10.2681 -22.4015 -23.39 -3.54403 -505 1 10.3613 9.82386 12.3172 12.1455 12.129 19.7304 -506 2 11.1427 9.8808 12.9129 -10.2174 -2.53791 -7.09814 -507 2 10.1997 8.88396 12.252 -0.966331 -12.4705 -0.927319 -508 1 0.481536 2.83002 7.02126 3.70324 23.8076 -10.0458 -509 2 0.770856 3.62826 7.51109 -3.83076 -19.2444 -0.666321 -510 2 0.694466 2.06428 7.55035 5.7415 -3.83046 10.8422 -511 1 0.467049 15.2425 6.91705 -4.45928 -38.0226 -11.2702 -512 2 0.600151 15.6263 7.78281 2.30728 -6.41275 13.0317 -513 2 0.61271 14.2361 7.00049 -2.84554 47.7716 -5.16909 -514 1 16.9541 7.01237 15.3291 23.6374 -7.48971 -3.1828 -515 2 17.7457 7.53254 15.1705 -1.99719 18.034 -6.10418 -516 2 17.38 6.19105 15.5941 -13.3003 -10.4743 0.120416 -517 1 9.01017 12.4224 8.1441 -46.2717 9.6088 -11.1501 -518 2 9.26268 11.8248 7.45061 25.2615 -14.9445 -10.6927 -519 2 8.05034 12.5239 7.91838 26.5695 6.53823 20.3475 -520 1 1.26455 1.94093 3.05316 3.58571 9.71968 -12.011 -521 2 1.22461 2.59742 2.34045 -8.12686 -11.986 1.71554 -522 2 1.93366 2.31359 3.63129 0.35358 -2.72116 4.87465 -523 1 4.13309 15.1146 9.63821 -4.623 1.46382 -0.938733 -524 2 4.12694 15.148 8.67475 -7.89004 5.45838 -0.100118 -525 2 4.98588 14.7259 9.81048 11.3537 -4.87926 10.963 -526 1 7.17766 2.17952 14.5652 7.62536 9.73749 11.0593 -527 2 6.96972 1.69872 13.7643 -0.327528 -0.451328 -7.35604 -528 2 7.66158 2.98182 14.3072 -3.86315 -8.18785 -0.50787 -529 1 18.6094 14.7115 2.1553 18.1066 -29.4746 -3.14947 -530 2 0.852094 15.108 2.23259 -6.38197 3.09186 -0.259441 -531 2 17.9366 15.3527 2.32074 -15.2526 23.2774 3.26778 -532 1 9.94663 2.7868 12.9455 2.69617 -13.1789 -11.1834 -533 2 9.77369 2.19316 12.1903 7.43131 1.21406 6.14773 -534 2 9.20096 3.38667 12.9408 -6.30409 9.38042 4.37845 -535 1 2.80852 8.91644 13.0153 -16.8956 -9.28674 -0.0207487 -536 2 3.13809 9.78934 12.8448 9.36486 20.7895 -4.33486 -537 2 3.52774 8.43066 13.407 13.2058 -10.3846 6.75792 -538 1 3.23128 8.35577 3.63883 6.10249 8.71431 60.2633 -539 2 3.54401 9.08838 3.13137 7.96401 15.5303 -21.3649 -540 2 3.46232 8.64756 4.58519 -13.4978 -19.9669 -35.5279 -541 1 5.63324 7.19832 8.5125 -13.133 -10.0414 6.96154 -542 2 5.51092 6.25688 8.34615 12.8941 -5.44374 -4.51219 -543 2 4.92213 7.36133 9.14092 2.83191 13.4678 4.26874 -544 1 14.878 1.27944 2.0109 -7.35803 -30.2596 -13.1701 -545 2 14.8616 1.98275 2.64555 4.54601 24.3613 2.83628 -546 2 15.264 1.50064 1.14913 0.22226 12.7122 6.62367 -547 1 8.2353 15.1956 0.84899 9.2054 13.6294 -15.3468 -548 2 9.04355 15.0937 1.38227 -7.5254 -5.87742 4.76726 -549 2 7.50355 14.6763 1.20804 4.58246 -4.32042 7.88142 -550 1 15.6328 1.34461 7.23795 -19.9173 -11.1245 -9.46976 -551 2 14.9591 0.718796 6.85982 16.5955 19.1651 8.9454 -552 2 15.1508 2.16575 7.45752 1.02199 -7.71962 -3.30529 -553 1 4.91374 13.0908 18.526 15.2565 -4.60213 14.3208 -554 2 5.33439 13.1154 0.77269 -6.07604 1.59812 -16.6926 -555 2 5.51105 13.5936 17.9543 2.83588 -2.74206 0.160853 -556 1 15.3493 8.4742 18.1502 12.1518 9.73195 -18.1744 -557 2 15.7592 9.1135 17.5088 -10.0207 -13.011 16.7995 -558 2 15.2243 8.95162 0.336167 -0.033387 6.18709 -0.40176 -559 1 12.0721 3.03363 18.372 7.89134 -10.3745 2.1206 -560 2 12.0185 2.56449 0.551271 -8.88822 8.03447 17.3967 -561 2 12.5632 2.36483 17.898 4.02516 4.57474 -24.0136 -562 1 13.2076 12.6757 5.17908 4.47921 -5.37266 1.03993 -563 2 13.7293 11.9632 4.79272 -2.12471 -1.88137 -7.76598 -564 2 13.3867 12.5644 6.11349 -3.52883 8.17381 9.78336 -565 1 6.04737 7.04753 0.0353989 10.049 -23.447 -5.31085 -566 2 6.01346 7.99319 18.6275 -7.37118 27.2698 7.20756 -567 2 5.32085 6.74358 0.593628 -6.10646 3.40609 1.47388 -568 1 17.7373 16.0235 15.0083 12.9173 -11.5355 46.7271 -569 2 16.9426 16.5159 15.2406 -3.68569 -0.0523083 -17.9381 -570 2 17.9142 15.8937 14.0864 -12.7219 4.58342 -31.2732 -571 1 13.1912 1.0014 16.5506 10.6966 -14.1722 10.2872 -572 2 14.1553 0.911674 16.6931 -11.9901 3.10273 -3.01829 -573 2 12.8874 0.074803 16.5753 -2.30324 8.04411 -4.14072 -574 1 11.1133 14.5665 7.20897 13.0955 23.3619 -16.6223 -575 2 10.3963 14.2935 7.74934 -21.4591 -15.3449 18.7975 -576 2 11.8402 13.9563 7.34501 4.8973 -5.05394 6.63835 -577 1 17.5096 8.63113 2.08657 0.966478 12.3426 12.6691 -578 2 16.6632 8.50317 2.50987 -10.5053 2.55961 10.3047 -579 2 17.5113 7.91267 1.47949 7.23292 -21.4893 -25.4513 -580 1 12.353 7.99884 2.01581 -2.70101 10.6364 -12.6504 -581 2 12.1945 8.88312 1.63494 1.68617 -6.44935 12.5501 -582 2 11.9639 7.41552 1.35659 -1.58766 -9.18843 -2.08326 -583 1 11.8879 14.6194 10.3406 -20.0746 -33.6598 -22.8547 -584 2 12.0361 13.784 9.8263 4.17148 28.2224 18.5196 -585 2 10.9018 14.6878 10.3309 21.6541 8.7111 3.83339 -586 1 6.88836 7.04362 15.6058 16.1194 20.5136 16.4981 -587 2 7.8035 7.27617 15.3369 -14.4637 -10.2261 -3.41305 -588 2 6.75267 7.59066 16.4113 -4.12685 -13.7627 -18.0291 -589 1 8.00073 4.72844 13.473 32.6072 13.4681 12.0072 -590 2 7.24466 4.78195 12.9199 -26.1194 -0.34176 -19.7698 -591 2 8.43099 5.60279 13.3668 -6.56701 -17.694 4.3215 -592 1 13.409 12.181 14.2619 -2.29334 -12.519 -3.59046 -593 2 13.0674 11.2691 14.1939 2.47622 3.528 5.79283 -594 2 13.8091 12.3245 13.3914 2.14013 7.29019 1.49174 -595 1 14.8335 9.42126 7.30208 -1.23415 -9.7028 -7.755 -596 2 15.6553 9.87909 7.43544 15.0677 5.06613 0.278043 -597 2 14.1895 10.0298 7.62302 -19.0881 6.3544 7.09879 -598 1 12.6523 17.0615 3.07749 -9.63712 20.8437 4.73829 -599 2 12.9489 17.4748 3.92954 -9.59054 -7.90452 -22.4084 -600 2 12.0211 17.6908 2.6147 24.5964 -20.1603 22.3384 -601 1 1.16316 7.14216 17.4575 -7.53687 9.98877 -12.7143 -602 2 0.304551 7.18474 17.9202 3.89796 -5.88799 -6.19513 -603 2 1.03245 7.53978 16.5617 1.30151 -5.77621 16.2427 -604 1 12.7701 5.15004 15.6505 19.6392 -10.8067 9.95473 -605 2 13.4563 4.50157 15.9538 -13.2351 19.2956 -11.0391 -606 2 13.2014 6.03319 15.6187 -0.0564141 -13.897 1.41482 -607 1 2.5292 3.39223 4.98971 -11.294 24.8894 43.5462 -608 2 1.79321 3.13497 5.63732 25.431 9.26734 -19.6171 -609 2 2.95221 4.24201 5.36402 -18.0427 -37.3772 -14.0443 -610 1 8.3195 11.2975 13.4498 34.4282 -42.0873 60.0692 -611 2 8.53145 10.9623 14.3727 -32.5783 27.093 -24.5589 -612 2 9.06913 10.8398 13.0623 -1.46455 6.72769 -32.5395 -613 1 12.8789 1.33599 13.3369 -0.326833 21.0111 -2.4484 -614 2 13.4114 1.42549 12.5087 -12.3149 4.19021 14.3531 -615 2 12.3728 2.16885 13.5095 17.1543 -18.8215 -15.124 -616 1 6.3438 13.6989 2.14861 -9.76603 2.4566 0.239062 -617 2 5.66699 13.9965 2.80165 17.5467 -9.19207 -8.6938 -618 2 6.94024 13.0708 2.57673 -0.273551 -0.649347 7.27334 -619 1 15.9211 6.60722 12.7931 -16.6599 -18.553 -4.38331 -620 2 16.3967 7.19214 12.2261 12.0088 12.5524 -15.4249 -621 2 16.3823 6.6241 13.6257 5.92705 1.19016 14.7721 -622 1 16.8355 0.712467 9.59592 -3.36362 -23.3789 -3.56206 -623 2 16.7779 18.376 9.75078 1.74957 20.9638 -0.413143 -624 2 16.4581 0.840534 8.70411 1.17104 2.38037 5.50581 -625 1 6.14488 11.7511 8.38011 -0.18946 -41.167 -3.37934 -626 2 5.27459 11.5011 8.78729 18.3987 2.85732 -10.3128 -627 2 6.60987 10.8879 8.11154 -22.1828 30.5528 10.1053 -628 1 2.89693 8.62105 0.44295 -56.4203 1.00956 -31.5069 -629 2 2.27197 8.22062 18.4324 34.822 -7.67477 5.45833 -630 2 2.23776 9.23156 0.789096 17.398 15.3469 20.296 -631 1 10.1637 10.4615 6.50349 -4.04384 3.34709 -8.13679 -632 2 10.5967 9.72069 6.94847 1.64295 -0.870339 0.249421 -633 2 10.4974 10.4621 5.5852 -1.057 -0.999308 12.8758 -634 1 6.73224 15.6973 6.55436 -2.09809 -5.48823 4.73835 -635 2 7.11043 16.1412 7.33204 2.41282 1.16671 -8.98558 -636 2 7.01002 16.1566 5.74315 2.18916 7.51026 7.17736 -637 1 6.44608 13.1679 5.58195 -4.20705 -14.9444 9.79279 -638 2 6.65412 13.9682 6.06813 3.08652 7.67851 0.170606 -639 2 6.07667 12.5708 6.24938 0.761343 1.39557 -4.00611 -640 1 16.8208 12.5604 9.84104 -2.42329 -13.6856 -22.0974 -641 2 16.9708 11.9197 9.11347 0.32984 0.887075 14.5477 -642 2 16.637 13.3652 9.35916 0.987515 11.3295 4.43609 -643 1 6.04174 2.95051 2.84722 -0.719082 -29.0389 17.5165 -644 2 6.39757 3.79665 2.63265 6.28437 26.7212 -14.5644 -645 2 5.5959 2.56013 2.08759 -0.264068 2.45464 -11.4985 -646 1 10.912 3.32579 3.30021 -11.54 -3.72468 -0.286686 -647 2 10.265 3.99241 3.57025 6.99069 0.708994 3.18227 -648 2 10.4899 2.90229 2.54711 3.22659 -3.75767 -5.68185 -ITEM: TIMESTEP -20 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.70913 7.06604 17.9499 1.08039 -7.3052 -10.6944 -2 2 7.76309 6.93671 18.0927 2.86377 -0.0634365 6.14939 -3 2 8.89082 6.62218 17.113 -0.435012 1.17195 3.96762 -4 1 18.5701 8.27154 6.84569 7.63886 -4.25596 16.0618 -5 2 0.0770478 8.01704 5.94511 2.80666 -2.10014 -27.175 -6 2 0.448594 7.6266 7.34851 -2.05713 5.96795 6.45131 -7 1 8.39922 18.5714 6.82203 6.72948 10.2859 -1.45868 -8 2 9.32775 0.155905 6.65662 -6.00666 -1.87083 0.283604 -9 2 7.88802 0.6421 6.41318 2.19693 -3.22314 0.641978 -10 1 6.59462 1.83749 11.6886 4.57701 1.91935 4.50468 -11 2 5.92153 2.26167 12.2253 -5.29818 6.79114 -2.36061 -12 2 6.2022 0.990271 11.4833 -4.39091 -13.1588 -5.35683 -13 1 7.12455 5.7334 2.35273 -30.6289 32.8622 11.4294 -14 2 6.61502 6.28908 3.00258 14.1285 -25.9969 -7.59408 -15 2 6.93422 6.24286 1.54682 10.1555 -14.3812 -3.81516 -16 1 16.2065 10.1646 16.1262 8.40668 11.1152 -6.07805 -17 2 17.0895 10.2474 15.7446 -2.7739 -5.15617 3.84543 -18 2 15.9438 11.0841 16.2665 -7.12418 -3.1551 3.11568 -19 1 10.6155 14.9936 2.32061 -1.92123 -0.42827 -4.10202 -20 2 10.587 14.5409 3.17342 -1.90113 -4.17135 2.45193 -21 2 11.1106 15.7965 2.49753 3.42935 4.58062 3.08668 -22 1 17.1538 8.25609 10.4362 5.05968 0.945942 4.2849 -23 2 16.7065 8.97876 10.9029 -1.41924 -5.56537 3.25582 -24 2 18.0123 8.61559 10.168 -2.45464 0.72557 0.389593 -25 1 14.8661 15.8683 16.3562 3.75833 -10.1031 -0.407994 -26 2 13.9609 16.1531 16.2809 -17.2441 8.84265 -1.93831 -27 2 14.8525 15.2671 17.1114 5.79928 3.60638 8.20478 -28 1 12.159 13.3907 0.439783 -6.21112 9.36015 -5.49833 -29 2 12.0312 13.5738 18.1447 5.07318 -6.56614 -2.93527 -30 2 11.6434 14.08 0.875998 -3.18612 -5.19303 11.2101 -31 1 9.2695 5.40921 4.0396 -15.9764 -20.2303 6.13461 -32 2 8.8083 5.02157 4.82949 8.30048 18.0685 -17.5094 -33 2 8.61456 5.30675 3.30783 11.5288 9.4755 11.0493 -34 1 1.82939 4.25621 11.6493 -6.71206 2.38393 -0.709376 -35 2 1.74358 5.20905 11.8686 0.595776 -11.527 -1.23597 -36 2 2.30823 3.82152 12.3665 0.967745 0.8605 0.134832 -37 1 1.98223 6.83069 8.36497 -5.35455 0.0641687 -19.1444 -38 2 2.41924 7.2303 9.11786 5.68758 -2.51321 7.89524 -39 2 2.03012 5.87061 8.47368 0.241822 -0.370612 9.81388 -40 1 5.39801 4.40718 7.93771 10.9733 2.82986 12.12 -41 2 5.47637 3.44759 8.05616 -6.09239 2.90192 -10.948 -42 2 4.7514 4.61131 7.25273 -1.49389 -3.85519 0.176314 -43 1 3.26825 2.92232 17.539 -14.9988 14.8633 6.4114 -44 2 3.91862 3.43305 17.0175 -2.74895 -4.28964 2.11315 -45 2 2.69145 3.57031 18.023 20.6758 -7.505 -11.8237 -46 1 7.47034 5.2735 6.10589 -2.49502 5.37071 -3.04547 -47 2 7.84271 5.98269 6.68437 -5.78386 -20.7203 -0.884416 -48 2 6.94663 4.6123 6.60405 7.6241 17.9385 5.03136 -49 1 9.77266 7.01281 11.9821 10.4665 -1.38292 10.7277 -50 2 10.3585 6.42202 11.517 6.59042 -6.6592 -2.49871 -51 2 9.12807 7.25863 11.3259 -16.7919 6.8996 -8.63143 -52 1 14.096 3.56038 8.06303 -5.03459 -1.11151 -11.1946 -53 2 13.7156 4.24767 7.5046 0.899669 0.845681 1.92473 -54 2 14.4812 4.01512 8.80943 2.7486 3.89851 9.64387 -55 1 4.73966 17.2567 4.00996 -0.195125 14.326 -18.5317 -56 2 5.55163 17.7707 4.1353 -4.1295 -8.09403 5.71009 -57 2 4.38972 17.5915 3.15482 -7.00181 -7.87351 15.3992 -58 1 16.5025 16.6092 10.0733 13.1432 9.20378 8.07617 -59 2 15.9712 16.6856 10.8668 -9.96451 -5.5735 1.54085 -60 2 15.9848 16.1464 9.41138 -7.70063 -5.20479 -0.44901 -61 1 1.97052 4.91045 0.450899 1.06366 9.69844 4.9192 -62 2 2.61093 5.33981 1.06219 -5.49885 -10.5105 -8.09306 -63 2 1.57388 5.6737 18.6422 7.70456 -7.85061 -0.972244 -64 1 11.7662 13.3441 16.2815 -7.88535 5.38496 10.7421 -65 2 11.2704 12.5109 16.442 6.50023 4.10664 -10.6094 -66 2 12.3479 13.2575 15.5066 -9.92493 -12.14 1.82083 -67 1 10.1201 11.0576 16.9389 3.39974 -19.6625 0.923124 -68 2 10.5319 10.1651 17.0061 -5.17122 15.3709 -2.15755 -69 2 9.17725 10.8754 16.8052 5.13113 2.71984 -2.06215 -70 1 11.7111 17.5152 13.4588 11.325 -2.75861 -1.19784 -71 2 12.3718 17.1152 12.8813 -0.632983 -4.36671 1.26506 -72 2 11.9961 18.4406 13.4806 -4.40298 2.90056 2.38202 -73 1 6.35795 9.30394 12.2283 8.95317 6.42027 -9.35456 -74 2 6.91663 9.09838 11.465 -5.59359 -11.5346 -0.139091 -75 2 6.8458 10.0391 12.6013 -0.320164 5.49925 11.3434 -76 1 16.2195 12.7457 2.69542 0.295574 -29.3957 1.13627 -77 2 17.0216 13.1501 2.38091 9.97003 13.3951 -1.47132 -78 2 15.5842 13.4209 2.91145 -9.8096 20.1499 -2.69183 -79 1 0.634077 12.5728 5.88372 -7.9484 2.86768 -4.89493 -80 2 0.988616 12.3569 5.00851 -6.1101 5.76055 1.83916 -81 2 18.334 12.7959 5.71409 15.811 -6.64636 4.43625 -82 1 5.2077 16.407 18.4749 -9.68849 -0.552221 -6.28119 -83 2 5.84718 15.7794 18.0984 2.41425 5.32286 5.94338 -84 2 5.56586 16.8292 0.618687 8.26881 -4.78153 -1.34873 -85 1 0.531249 7.63213 4.08542 33.6963 23.9515 -16.2824 -86 2 18.6021 7.94352 3.35108 5.75308 0.311196 11.7347 -87 2 1.44781 8.03396 3.8909 -38.1012 -20.2476 4.98268 -88 1 3.13519 8.90219 6.5128 -18.1806 -1.10975 19.7922 -89 2 3.61721 8.66647 7.3217 -0.167991 0.711605 -10.7948 -90 2 2.18954 8.88363 6.78472 17.5501 0.713198 -9.35234 -91 1 7.30642 10.3086 16.1993 0.33826 1.86993 11.5423 -92 2 6.5825 10.5097 15.5962 -1.40069 -1.74837 7.12047 -93 2 6.94436 10.2588 17.1142 -3.68695 0.804433 -15.344 -94 1 11.1033 1.05136 4.99998 6.51415 -6.68887 15.4104 -95 2 11.3804 1.86173 4.55399 -8.93638 -1.72916 -9.27788 -96 2 10.7652 0.40817 4.35737 0.804793 8.53975 -5.36269 -97 1 4.41906 2.71829 13.1993 1.75265 -17.8891 31.6776 -98 2 4.61925 3.15892 14.0364 2.0928 12.2335 -7.50334 -99 2 4.34595 1.79439 13.5397 -3.31279 7.49147 -22.0731 -100 1 8.39429 10.0534 1.8011 7.989 6.96853 5.58503 -101 2 8.43083 10.7556 2.48299 -4.47719 -6.35615 -3.34103 -102 2 8.76263 9.25633 2.22388 -6.49712 6.95404 -2.63041 -103 1 10.5097 1.74962 15.5619 -18.3761 -0.922722 7.55335 -104 2 11.4225 1.47346 15.6803 4.80494 4.8298 -6.32182 -105 2 10.3374 2.00269 14.6445 6.81104 -1.01801 -3.49857 -106 1 2.7507 12.9226 7.76103 -0.99391 -3.54814 -5.35437 -107 2 3.2837 13.6196 7.35675 1.026 0.47841 4.16479 -108 2 2.1823 12.6261 7.03948 -5.64928 1.37633 4.69044 -109 1 3.65655 11.6901 5.29539 -1.74666 1.04695 -5.47464 -110 2 3.42979 10.9863 5.91968 -0.390133 2.11749 -7.53732 -111 2 2.90341 11.8434 4.69867 6.59799 -3.91283 3.78854 -112 1 6.86195 14.4839 16.8677 -6.59977 -5.37582 9.26387 -113 2 7.63594 13.9204 16.7929 -0.0312736 1.63672 -3.94334 -114 2 6.43125 14.5303 16.0039 6.73415 3.59122 -3.18668 -115 1 14.1795 14.5536 3.39757 15.4782 -5.44823 -10.5 -116 2 13.7027 15.3725 3.25557 -8.02005 3.41109 -0.200737 -117 2 13.6761 13.9828 3.97966 -5.46722 0.130817 9.75683 -118 1 8.30625 18.1704 16.0558 -18.3501 -5.93921 0.16691 -119 2 8.73243 17.3486 16.3757 13.662 16.7968 -4.53324 -120 2 8.86048 0.311637 15.8745 11.2379 -14.2941 4.19403 -121 1 4.7262 1.6175 4.92485 1.6266 19.4211 -17.3379 -122 2 3.85517 2.05812 4.84475 13.0303 -7.24689 7.72044 -123 2 5.31448 2.15314 4.34837 -14.7695 -11.1634 6.67198 -124 1 15.0789 12.7964 16.4332 -6.30353 8.33681 17.3183 -125 2 14.5699 13.1854 17.1557 10.6035 -4.81202 8.18161 -126 2 14.431 12.7912 15.7403 -5.45963 -10.7064 -24.7799 -127 1 15.7876 18.4014 16.8102 7.97993 -1.6905 34.0366 -128 2 16.3475 18.509 17.631 -13.1355 2.97046 -27.3317 -129 2 15.4303 17.5059 16.9211 5.07282 4.66478 -9.26997 -130 1 1.15379 1.15776 16.5585 8.66192 -1.89028 -5.04545 -131 2 1.90132 1.75074 16.7615 -7.4852 -3.92147 5.78546 -132 2 0.484053 1.2881 17.242 6.61018 5.41271 -0.381602 -133 1 18.0958 4.56873 15.8951 8.25715 -8.22974 -2.59939 -134 2 18.5403 4.03662 15.2192 -4.31028 2.25805 3.56674 -135 2 18.6753 4.5681 16.6654 -3.11748 0.528024 -3.18079 -136 1 12.2229 16.9717 16.1366 4.99185 -14.9968 15.1993 -137 2 11.5697 16.3784 16.5746 6.13992 18.0067 -10.7689 -138 2 12.0903 16.9196 15.1862 -11.661 1.79059 -6.40221 -139 1 15.9175 2.52925 17.9868 -5.04918 24.4496 -1.91719 -140 2 15.7053 3.35036 18.4645 1.43445 -9.55155 0.206063 -141 2 15.6037 2.74854 17.0829 8.19816 -13.208 8.21894 -142 1 6.7035 13.812 10.2396 3.19471 14.7437 0.534165 -143 2 6.61208 13.6203 11.1841 -1.85117 -10.3739 -2.65392 -144 2 6.65674 12.9942 9.7292 -2.15383 -4.24588 3.01674 -145 1 10.13 18.2471 2.79005 6.2323 7.4499 -7.90816 -146 2 10.2641 0.289717 2.1086 -4.88175 -4.44055 6.63338 -147 2 9.27512 17.8471 2.59242 -0.00557908 4.28296 0.85488 -148 1 2.97726 17.7544 6.09154 9.3411 -8.798 -12.7807 -149 2 2.21419 17.6669 5.51339 -17.57 2.09099 8.77855 -150 2 3.67394 17.6484 5.43984 9.00485 8.25893 -0.00709571 -151 1 12.565 16.9537 7.99058 7.14198 1.79921 -4.31208 -152 2 11.8238 16.3251 7.88339 1.67036 10.005 4.65414 -153 2 12.3624 17.6704 8.62526 -6.57036 -14.6618 3.16709 -154 1 14.8823 15.2807 8.26789 -1.91265 -14.526 28.7428 -155 2 14.153 15.9118 8.23916 -2.47753 6.09246 -10.9919 -156 2 15.4304 15.3156 7.48892 0.613021 10.1448 -23.5664 -157 1 17.5919 18.2849 0.376053 -34.2379 -2.64943 -3.08159 -158 2 18.3697 17.8673 0.0312256 25.6277 -7.0964 -1.13253 -159 2 17.798 0.454484 0.829223 12.3697 7.05842 3.85092 -160 1 0.890355 10.3869 1.40531 11.5261 -26.8893 18.421 -161 2 0.106732 9.81739 1.52594 3.68606 12.403 0.666184 -162 2 0.670163 11.0869 0.811123 -14.943 21.2909 -16.3167 -163 1 1.59243 12.2061 3.32787 10.8868 -1.98125 32.4665 -164 2 1.41581 11.4302 2.79423 -4.35317 -0.696655 -17.6875 -165 2 1.68603 12.9921 2.7891 -2.29445 2.46974 -13.9165 -166 1 0.556424 17.2525 4.88159 28.516 -3.31441 -27.2608 -167 2 -0.112492 17.9263 4.93691 -11.7284 7.93843 13.1539 -168 2 0.513874 16.5834 5.55808 -11.2757 -6.6263 16.6148 -169 1 1.11617 0.979823 9.41029 -8.01472 5.90786 -6.49609 -170 2 1.17088 0.754182 10.3385 12.3333 -8.44182 10.8127 -171 2 0.193916 0.78552 9.22994 -1.98368 -3.92324 -6.63209 -172 1 16.7786 2.33534 13.2836 0.301257 -1.02782 -8.61363 -173 2 16.9098 2.55877 12.34 -0.551981 -1.96326 12.3514 -174 2 16.5533 1.39033 13.3371 -1.81134 4.54396 -2.66642 -175 1 2.50838 15.8231 12.1881 11.0759 -0.61625 -4.91684 -176 2 3.05623 15.4799 12.9137 -5.11001 1.87196 -7.11666 -177 2 2.97562 15.6336 11.349 -1.75425 -0.738878 7.05871 -178 1 16.4241 15.5762 5.95419 20.8818 34.7414 3.73321 -179 2 17.3417 15.6388 6.29893 -10.1511 -9.39035 -1.02331 -180 2 16.3256 16.4387 5.46724 -6.92566 -23.7939 4.29358 -181 1 5.82318 5.04015 11.787 7.38202 -1.28642 -1.97288 -182 2 5.53279 5.76584 12.3478 -8.19426 6.74642 1.34004 -183 2 5.25308 4.28957 11.9879 -3.19521 -0.0404241 -0.10221 -184 1 15.2058 4.86095 0.714988 -15.0911 -0.578133 32.6943 -185 2 15.0554 4.65905 1.68214 1.80466 1.09263 -27.7183 -186 2 14.3514 5.22673 19.0716 10.184 -3.76227 -2.57358 -187 1 16.3414 16.3313 2.1188 1.69452 -20.4231 -15.1031 -188 2 15.9696 16.7397 2.89766 0.772445 11.9995 9.83785 -189 2 16.487 17.0139 1.46036 1.64169 8.90638 2.00624 -190 1 0.27953 4.87193 3.80304 22.0083 21.7264 1.42732 -191 2 0.488965 5.84197 3.75834 -13.581 -23.7134 5.51739 -192 2 1.12962 4.47493 4.05501 -10.8528 -1.93786 -0.672788 -193 1 2.93644 15.0118 15.0505 -0.31189 -6.67479 38.4938 -194 2 2.77152 14.5973 15.941 9.17422 6.49202 -18.5047 -195 2 2.6087 15.9081 15.2082 -8.55577 3.59906 -10.383 -196 1 1.11893 14.5977 9.54871 15.5404 -15.1461 3.70851 -197 2 2.05973 14.499 9.39244 4.56619 15.8955 -5.72674 -198 2 0.980037 13.7309 9.94382 -18.1835 3.0763 3.0761 -199 1 13.6623 16.6444 11.5318 -24.61 2.13122 1.95847 -200 2 13.1623 17.4223 11.2076 12.7863 -8.68657 -5.97173 -201 2 13.1098 15.8918 11.2458 9.29846 2.29742 -4.43006 -202 1 4.71401 1.48013 0.724257 -0.188744 -1.90188 8.47653 -203 2 4.10877 2.04213 0.209428 1.54459 -7.39683 1.44825 -204 2 4.1847 0.878426 1.28084 -4.13807 4.124 -10.8706 -205 1 1.4317 18.499 11.8861 -0.747589 2.74228 -9.05649 -206 2 1.26248 0.376362 12.6752 -1.22453 3.10674 7.57799 -207 2 1.76508 17.6414 12.1696 1.67944 -1.01146 1.59049 -208 1 11.5426 10.114 4.08871 14.5973 5.39555 -25.8673 -209 2 11.3947 10.5181 3.18641 4.0612 -8.18021 22.6028 -210 2 12.5241 10.0302 4.19261 -20.6338 4.9276 -1.52234 -211 1 8.35442 12.1679 3.75067 -15.8416 -4.27069 -7.38356 -212 2 9.18656 12.6319 3.95442 -10.6107 -0.215004 12.2135 -213 2 7.67679 12.3128 4.45645 22.0699 3.83678 -6.48541 -214 1 14.3334 4.02625 3.28975 21.4077 6.9275 8.44763 -215 2 15.0849 4.22802 3.89908 -16.2072 -5.96795 -3.3621 -216 2 13.5509 4.49592 3.62574 4.82101 -0.669553 -3.42678 -217 1 5.57933 1.73516 7.50739 -24.0378 -31.7376 11.0088 -218 2 4.91074 1.07012 7.91595 32.7583 31.1537 -18.2093 -219 2 5.45045 1.65908 6.53973 -4.97377 0.997246 11.1506 -220 1 17.8945 1.1186 4.8831 -1.36037 -2.43827 -6.93143 -221 2 18.5804 1.42855 4.26031 -6.60553 2.78724 7.64102 -222 2 17.8025 1.76232 5.59874 4.87877 0.216211 -3.29328 -223 1 6.83024 9.40422 4.48506 -14.9488 0.581331 -12.2421 -224 2 6.75886 9.5424 5.43046 9.61942 2.86103 10.3107 -225 2 7.75214 9.21615 4.27366 4.86133 -4.03573 4.34319 -226 1 2.68867 14.9529 1.96243 -3.68441 -0.0776758 1.15821 -227 2 3.24659 14.6776 2.70632 3.58292 1.9147 -7.42106 -228 2 3.21497 14.9558 1.15083 1.81588 -2.88288 8.16929 -229 1 17.2949 12.8929 13.1574 -7.5849 14.4302 -4.04848 -230 2 16.4401 13.3055 13.2858 -13.783 -13.5119 9.83474 -231 2 17.7157 13.6748 12.8001 24.9453 0.592093 -1.55303 -232 1 15.0095 10.5719 1.38917 -11.2702 -15.2105 -5.46509 -233 2 15.5687 11.2426 1.76309 11.9887 12.322 8.95719 -234 2 14.2298 11.0424 1.10476 -6.47688 3.25886 -0.810136 -235 1 5.70264 6.91192 4.53101 4.96234 -7.94583 8.40724 -236 2 5.98573 7.83684 4.52277 1.36545 -0.678753 -1.4492 -237 2 6.33051 6.43499 5.10591 -2.47306 1.6182 -5.79546 -238 1 8.0801 8.26782 10.1943 -2.48094 -3.5573 30.8197 -239 2 8.76371 8.85191 9.85613 0.308879 9.43682 -13.0265 -240 2 7.56027 7.88877 9.48994 -2.62488 -0.283604 -15.3664 -241 1 13.5 18.3149 5.7974 -5.02979 10.2931 3.81039 -242 2 12.85 0.37996 5.63415 -2.0272 -10.2183 1.79381 -243 2 13.182 17.8392 6.59435 1.6098 2.02728 -12.9685 -244 1 0.276709 2.57627 0.11216 -0.0492842 3.76989 10.2262 -245 2 17.9528 2.7291 18.6895 13.0336 8.33648 -1.41355 -246 2 0.811706 3.36861 0.368499 -21.4808 -7.42382 -6.02819 -247 1 12.6714 10.9997 9.76016 -23.5437 -7.71308 -4.31472 -248 2 11.7133 10.8659 9.59681 15.3229 11.3368 0.532821 -249 2 12.914 10.0869 9.9422 13.3726 -3.72203 6.47581 -250 1 0.779958 12.2601 11.0819 -4.3547 -6.1438 5.62044 -251 2 18.4678 12.2984 11.1653 -6.51403 -1.20026 -7.70008 -252 2 1.07438 12.4529 11.9792 8.34734 4.57522 -3.24255 -253 1 5.0586 7.24501 13.467 -14.0099 -7.28532 -8.10759 -254 2 5.49528 8.03405 13.1289 12.6282 1.90126 -2.15469 -255 2 5.51501 6.98287 14.2704 7.34444 5.85192 6.7727 -256 1 1.26105 6.94281 11.8301 -2.26861 -4.26975 2.97 -257 2 0.502637 7.2894 11.3564 -2.98104 -0.152382 -1.57853 -258 2 1.67901 7.71469 12.2201 5.00338 4.10874 -3.32488 -259 1 15.4732 9.48624 12.3091 -7.90575 31.4836 20.4854 -260 2 15.2888 10.4503 12.3878 3.68649 -17.5592 -11.9783 -261 2 15.3484 9.17907 13.2194 3.56004 -6.14635 -9.9625 -262 1 16.6235 12.9071 5.45115 4.22183 -17.5767 13.0612 -263 2 16.4576 13.8585 5.58703 -5.89626 -6.38642 -16.4082 -264 2 16.4453 12.6107 4.54016 -1.61972 14.741 3.30454 -265 1 6.17978 10.0207 0.140312 6.69901 -0.902574 1.02107 -266 2 5.53175 10.4562 0.704359 -7.04498 -0.0752206 -3.29626 -267 2 6.99223 10.1412 0.643131 5.59964 -6.49227 2.85612 -268 1 12.3558 6.06094 4.04059 -1.82306 -10.4932 18.2897 -269 2 12.2948 6.89378 3.5711 -3.30175 6.87328 -14.7087 -270 2 11.4523 5.72881 4.15047 2.03572 4.51633 -5.92335 -271 1 0.151611 12.8143 0.201399 6.45324 -5.46068 -3.81056 -272 2 -0.0140355 13.4798 0.883392 3.4035 3.37155 -1.9342 -273 2 18.3672 13.1447 18.0414 -1.87626 -1.08321 2.97259 -274 1 3.81145 18.5877 8.5912 1.31461 -3.73146 5.16785 -275 2 3.56882 18.0432 7.82418 -6.49798 6.54364 1.53441 -276 2 2.99788 0.372962 8.89657 -5.11276 -3.31294 -4.1744 -277 1 7.4281 17.2705 4.47377 6.46179 23.4452 -11.2721 -278 2 7.96797 18.0618 4.61565 -3.66399 -5.46425 9.5792 -279 2 7.28703 17.3462 3.52078 -0.310988 -11.8901 2.26571 -280 1 9.22893 17.063 12.2466 22.6161 -18.3078 -0.374418 -281 2 9.25634 16.2959 11.6379 -2.98004 10.6911 5.23864 -282 2 10.0783 16.9759 12.7442 -18.2994 12.1316 -6.13803 -283 1 13.3197 12.9538 7.95187 -9.96581 2.72298 -9.05352 -284 2 13.2593 12.2563 8.62517 4.24613 3.77329 1.00191 -285 2 13.899 13.6706 8.22561 11.1032 -0.425478 9.75376 -286 1 14.9719 2.96045 15.3396 1.81329 0.120121 -0.870248 -287 2 14.3995 2.21229 15.1018 3.59949 7.50345 -3.65154 -288 2 15.6901 3.005 14.6772 -10.8991 -3.85704 4.22675 -289 1 9.85324 15.5257 17.0014 3.97317 -4.57748 -3.47476 -290 2 10.3864 14.7538 16.7592 -3.54516 -0.814303 -2.23392 -291 2 9.2485 15.2429 17.6987 -0.194096 3.36496 6.55889 -292 1 11.2976 8.26736 16.5426 7.06128 19.5884 6.19806 -293 2 10.6048 7.82655 16.0501 -2.15009 -7.46249 -5.1526 -294 2 11.6506 7.64084 17.1804 -3.23764 -5.26669 1.48715 -295 1 3.80261 18.1891 16.7286 5.96532 3.63646 9.58286 -296 2 4.2558 17.5705 17.3068 2.57751 -13.4277 -2.28373 -297 2 3.88923 0.356458 17.2317 -6.08372 7.81341 -6.39572 -298 1 2.19516 4.11859 8.94937 -6.46461 1.56382 -5.27436 -299 2 3.07192 3.77694 8.7043 -7.24867 0.753394 12.5906 -300 2 2.01364 3.98399 9.90559 16.1239 2.6739 -11.0998 -301 1 9.88488 10.3605 9.72172 5.12637 14.4569 -2.91242 -302 2 9.60959 11.2332 9.33432 -0.0101703 -19.6763 14.6837 -303 2 10.1282 10.4603 10.6632 -8.0115 2.48909 -7.97128 -304 1 9.71465 0.804575 10.8512 21.7431 15.3431 10.1505 -305 2 9.2832 18.6897 11.2643 -8.53487 -4.69507 -4.97966 -306 2 9.18676 1.22081 10.1628 -13.1132 -5.80645 -3.94121 -307 1 9.20675 15.1716 10.2106 -23.935 -1.88548 4.57185 -308 2 8.85892 15.9372 9.71979 2.38257 -5.68301 1.50138 -309 2 8.39577 14.638 10.4071 17.7258 6.53325 -11.5344 -310 1 1.0072 9.34307 10.3251 -13.5607 -2.30165 -2.87521 -311 2 1.0259 10.3094 10.4263 12.3488 -1.76633 0.307332 -312 2 1.88127 8.96784 10.1532 -1.03643 13.7416 3.72628 -313 1 16.8438 4.87108 8.18901 -4.78961 0.896955 11.5039 -314 2 16.1406 5.46499 8.54396 15.0863 -10.4307 -3.41532 -315 2 17.2081 4.33923 8.92353 -6.78534 8.8584 -10.8667 -316 1 14.6587 14.7041 0.366828 1.30507 -0.478814 3.63059 -317 2 15.185 15.0332 1.12636 -7.04307 -0.464202 -11.0373 -318 2 13.8385 14.3426 0.742198 8.82268 0.591631 -2.33039 -319 1 3.54036 11.0513 9.61487 2.50715 2.61524 -7.45538 -320 2 3.63629 11.5626 10.435 -2.71976 -6.10697 -0.243655 -321 2 3.06413 11.634 8.99273 6.16009 -0.263385 5.30284 -322 1 11.0628 10.8412 1.29387 1.94664 2.31063 1.36488 -323 2 11.3352 11.6508 0.816723 -4.4237 -7.82009 8.11802 -324 2 10.1138 10.7005 1.1254 8.25661 2.0034 -0.662671 -325 1 13.2071 7.092 12.8743 -8.181 6.96481 -7.78695 -326 2 14.1492 6.89693 12.9368 4.59729 -0.0390769 -2.26511 -327 2 12.7747 6.23567 12.7699 0.0352738 -4.27477 4.68983 -328 1 9.62872 1.89049 0.957357 1.17656 -1.16236 13.2501 -329 2 8.73134 1.77169 0.632677 -1.73422 -2.0126 -6.33446 -330 2 10.2301 1.88378 0.211292 -0.739962 2.15457 -7.7161 -331 1 10.5914 13.525 4.7165 6.94092 6.03141 -14.7136 -332 2 11.5001 13.1966 4.5902 -6.55933 -2.4681 12.9436 -333 2 10.616 14.067 5.5206 3.43098 -5.16043 -1.25188 -334 1 14.3018 1.72484 10.9172 13.4371 11.1223 -9.93713 -335 2 15.1272 1.43467 10.5035 -1.81024 -10.6133 4.43081 -336 2 14.4134 2.68551 10.8564 -6.433 0.422524 6.62217 -337 1 14.6521 12.3877 11.7022 -8.45049 -6.71538 5.80805 -338 2 15.5103 12.5052 11.2413 -17.7577 -5.57988 -7.54306 -339 2 13.9188 12.0751 11.1197 22.5147 4.82958 0.534535 -340 1 8.2427 5.06906 9.80652 6.55588 21.6544 3.19941 -341 2 7.41824 5.23391 10.2944 2.41744 -11.9303 -3.89737 -342 2 8.21758 4.20856 9.37923 -10.585 -10.7296 4.55255 -343 1 1.58459 16.8369 18.3321 1.96955 3.78018 0.59611 -344 2 1.85004 17.2184 17.4898 0.0469727 3.49377 1.52109 -345 2 1.98826 15.9645 18.3052 -5.87072 -8.1408 0.0386171 -346 1 1.45085 17.2397 15.3384 19.3024 -11.6024 -7.75777 -347 2 1.52928 18.1033 15.7334 -7.82156 13.9033 4.46915 -348 2 0.523156 17.01 15.2404 -5.15812 1.64021 5.22009 -349 1 3.71432 5.60797 6.16821 -6.42766 23.1509 5.2389 -350 2 3.10788 6.20238 6.65309 4.74203 -10.8724 -0.844938 -351 2 4.31902 6.23597 5.73943 -0.58891 -7.80382 -7.69424 -352 1 12.3617 9.44178 14.1897 14.768 -21.5294 -7.13739 -353 2 12.6854 8.60646 13.7318 -7.61852 23.4532 21.1317 -354 2 12.1886 9.19254 15.1239 0.0190459 -2.13671 -14.4759 -355 1 4.02789 15.2847 6.90037 19.6963 3.91174 -8.53909 -356 2 3.59813 16.0446 6.4807 -5.57314 -2.58109 7.58101 -357 2 4.98627 15.4174 6.72455 -14.0806 -2.64155 5.91133 -358 1 0.604694 8.56382 14.8836 6.38519 14.8729 2.46932 -359 2 0.593576 9.52815 15.0331 -4.38489 -7.16014 1.99766 -360 2 1.21683 8.48632 14.1406 0.0450847 -3.26888 3.80333 -361 1 12.9907 8.33553 10.3435 -10.7244 11.0212 -25.595 -362 2 13.7217 7.85043 9.92864 1.48882 -4.14748 10.5805 -363 2 12.916 8.06476 11.2563 9.06532 -10.0671 12.5191 -364 1 15.3021 7.67479 3.50456 -15.706 -31.6797 19.6454 -365 2 14.5991 7.08356 3.22123 -2.84665 13.9574 -20.9494 -366 2 15.4859 7.21773 4.34079 18.8178 22.1978 3.49889 -367 1 17.3057 6.66581 0.0439089 -0.566439 -0.157214 -4.14934 -368 2 16.9415 5.80914 0.322205 -4.36129 9.908 -1.962 -369 2 16.5386 7.21525 18.4101 8.51434 -8.37768 3.91558 -370 1 8.82219 6.93132 7.84612 -10.1525 -9.67927 6.48857 -371 2 9.74438 7.17539 7.82243 13.4851 9.91198 -3.74634 -372 2 8.75511 6.31699 8.60098 -3.86074 2.18846 -4.69843 -373 1 12.3417 0.621389 1.18077 -6.9564 -3.41972 6.83906 -374 2 13.1525 0.726993 1.70017 3.48999 0.0677543 -9.59522 -375 2 12.4857 18.5505 0.551479 3.63823 3.88808 0.842467 -376 1 5.6677 15.1168 14.5202 -2.89809 14.409 3.62726 -377 2 4.73779 15.2069 14.7798 -2.10515 -4.92641 -4.42493 -378 2 5.95698 16.02 14.2745 1.37709 -12.0745 -2.57764 -379 1 3.85174 6.50812 1.71549 -1.87326 -9.92841 -7.94113 -380 2 3.40118 7.27684 1.32447 4.40945 3.56133 7.79633 -381 2 3.98293 6.6854 2.65555 -2.72837 5.07562 -0.486349 -382 1 3.88774 11.6179 12.2731 7.36248 2.53406 3.74193 -383 2 4.74563 11.9961 12.5096 3.21135 -1.44769 -3.24982 -384 2 3.26188 12.2215 12.6852 -7.1456 -2.35069 3.20446 -385 1 5.4326 3.86602 15.8669 5.46195 27.5847 5.5501 -386 2 6.12196 3.19729 15.7751 -0.292732 -1.96119 -5.07149 -387 2 5.89955 4.7414 15.9262 -11.6823 -23.746 -2.53289 -388 1 14.4519 10.31 4.40466 -0.198609 -22.4452 -14.1251 -389 2 14.647 9.76314 5.18938 0.972168 3.21729 -6.37484 -390 2 14.6939 9.77999 3.59617 -3.45576 13.8176 24.0335 -391 1 7.91012 17.3396 9.21881 -3.47249 -5.09989 3.31179 -392 2 7.12992 17.5549 9.76562 5.48476 5.05439 -11.164 -393 2 8.00718 17.9294 8.44912 -7.46491 1.16212 7.11091 -394 1 4.51961 14.4455 3.97665 1.46094 13.6517 19.4367 -395 2 4.57851 15.3966 4.28178 1.46521 -27.5553 -6.05216 -396 2 4.65578 13.8277 4.74009 -3.41874 17.0045 -15.0106 -397 1 14.2914 7.39173 15.7568 2.67151 4.01398 13.8033 -398 2 15.2382 7.26829 15.5879 -5.04223 1.8615 0.0507223 -399 2 14.2621 7.71182 16.6758 1.37252 -0.910778 -10.0112 -400 1 2.89282 18.2219 1.89623 16.0954 20.7868 19.4211 -401 2 2.43498 17.5738 1.38145 -10.8581 -14.0242 -17.961 -402 2 2.20473 18.7378 2.33948 1.00824 -0.59586 0.163903 -403 1 7.97772 1.60288 4.53639 1.7563 -9.68985 13.008 -404 2 7.31922 2.029 3.97737 7.04095 6.46018 -8.6135 -405 2 8.84264 2.02013 4.43356 -4.53303 1.60821 -5.92451 -406 1 2.59943 14.1332 17.7414 -8.95394 -18.2677 -2.38171 -407 2 1.94944 13.4122 17.9464 12.5244 20.6844 1.19004 -408 2 3.47205 13.7759 17.9983 -8.8914 0.728457 0.900702 -409 1 0.745112 1.69912 13.8711 11.2473 3.52367 -11.146 -410 2 0.914419 1.4049 14.7673 -7.77297 1.70239 6.88788 -411 2 18.4589 1.93825 13.7842 -0.334419 -0.897106 4.15254 -412 1 4.53599 18.6175 13.9535 -3.4557 6.59794 -4.70782 -413 2 5.46815 18.3485 13.9788 -8.18255 -2.00556 -1.03369 -414 2 4.11637 18.3402 14.7801 5.6735 0.958275 2.99437 -415 1 7.096 0.531319 18.3551 -0.694611 7.4496 8.80978 -416 2 7.23097 0.178113 17.4735 2.95576 -3.96306 -6.42653 -417 2 6.14085 0.633472 18.4745 3.33236 6.58102 0.363951 -418 1 16.0915 18.4336 14.0959 0.427379 -0.396215 -8.58483 -419 2 15.3508 17.8946 13.7703 3.59427 8.97013 10.1541 -420 2 15.9721 18.7209 15.0186 -4.35198 -12.8399 -3.85995 -421 1 10.0849 4.5187 16.2702 4.73223 -5.50586 5.92697 -422 2 10.9866 4.63155 16.5807 5.77761 8.19399 -3.69287 -423 2 10.0461 3.5611 16.1717 -6.80252 -1.66686 -4.51665 -424 1 15.8725 17.8845 4.41654 -12.5209 12.7326 5.37596 -425 2 16.3916 18.7124 4.49019 -1.68969 -11.5252 -1.94643 -426 2 14.9593 18.1341 4.67479 17.449 -5.50076 1.40971 -427 1 6.95668 17.3709 13.7302 27.0332 5.97859 23.7699 -428 2 7.35597 17.5596 14.624 -6.60353 0.436933 -26.7426 -429 2 7.73328 17.3113 13.1176 -17.9234 -0.691624 11.5164 -430 1 13.2886 6.54141 6.708 -19.4099 -8.32294 21.4331 -431 2 14.1944 6.83212 6.62317 10.4169 5.52785 -11.9279 -432 2 12.8902 6.38702 5.85009 7.8467 0.777822 -14.5162 -433 1 7.70655 2.38278 9.20977 12.6343 0.60353 -10.8933 -434 2 7.2325 2.23152 10.0347 -6.87682 0.627979 2.4454 -435 2 7.14224 2.1131 8.46352 -1.96859 -1.38987 10.9664 -436 1 15.1599 14.8609 13.6555 2.14917 -2.72077 3.1958 -437 2 15.0894 15.1454 14.5818 -4.10533 -0.470809 -6.08849 -438 2 14.3857 15.1548 13.1581 4.50097 1.9243 4.2209 -439 1 9.31836 8.32368 3.71602 18.5592 -2.51714 11.5674 -440 2 10.1335 8.79007 3.99631 -8.14035 -3.14117 -4.90658 -441 2 9.4898 7.3827 3.90713 -7.2783 5.8685 -3.93333 -442 1 17.7186 13.4905 16.4359 -1.51289 22.2408 -13.156 -443 2 16.7625 13.3639 16.3649 1.62841 -7.26982 3.16217 -444 2 17.8329 14.3608 15.9953 4.68582 -10.1291 6.26608 -445 1 5.02763 10.6563 2.64305 -2.13744 -9.22816 3.31541 -446 2 5.67739 10.1782 3.18798 -3.0773 8.85482 -0.1212 -447 2 4.59818 11.3042 3.21285 3.70326 -1.5106 2.19329 -448 1 3.72149 8.34459 10.2919 -0.179455 -7.68631 -12.7595 -449 2 3.82782 9.26393 10.0171 0.460185 9.10653 3.72446 -450 2 3.7984 8.31763 11.2506 0.24707 1.5831 -0.943414 -451 1 16.0782 7.09232 6.27704 3.78536 -20.3998 -1.61032 -452 2 16.8668 7.5306 6.63092 -6.12864 4.03671 -1.53431 -453 2 16.2929 6.14181 6.32149 -2.48234 12.3559 -4.92911 -454 1 15.1572 7.02511 9.10581 3.8117 16.1939 -22.7388 -455 2 15.9823 7.33517 9.52567 -10.9007 1.4123 -2.48218 -456 2 15.0452 7.59247 8.29613 6.45133 -12.7204 22.5185 -457 1 6.42341 13.1088 12.8743 -8.95622 -6.97199 -8.56847 -458 2 7.13157 12.5608 13.2501 0.579484 9.04377 -2.95583 -459 2 6.27581 13.8943 13.4207 1.62934 -6.42573 5.92996 -460 1 12.1251 4.48872 13.0852 20.6978 11.8008 -11.4801 -461 2 12.1861 4.63134 14.0408 -7.38726 -2.06828 2.45652 -462 2 11.3124 4.06154 12.8314 -12.072 -7.43803 9.29181 -463 1 11.3394 8.19587 7.85205 11.1059 -10.4301 17.8484 -464 2 12.0348 7.61277 7.52234 0.357557 0.521252 -13.0071 -465 2 11.6101 8.269 8.78041 -6.91702 7.4869 -1.95681 -466 1 17.1867 10.7889 7.4395 14.5297 -2.81026 -23.5185 -467 2 17.9096 10.1869 7.16109 -12.9834 1.71839 15.1597 -468 2 17.0415 11.3048 6.62611 -4.1729 8.16775 12.482 -469 1 5.24074 18.1281 11.0581 -15.2173 -3.98599 -8.34189 -470 2 4.58924 18.0057 11.7782 10.2636 1.95052 -8.13419 -471 2 4.73144 18.0737 10.2167 7.33147 4.07832 13.9505 -472 1 7.57528 17.5815 1.8237 -4.07192 12.6902 15.9513 -473 2 7.93668 16.805 1.40258 -2.93669 -7.99436 -16.24 -474 2 7.56667 18.3008 1.17772 -1.22407 -7.09592 -6.98677 -475 1 1.89335 12.9293 13.6081 -2.83392 -4.38044 7.70492 -476 2 1.42634 12.2947 14.1785 7.13969 5.03303 -2.73416 -477 2 2.14611 13.6729 14.1857 -2.01709 -2.63559 -9.61881 -478 1 9.71667 6.79197 14.8165 -19.737 27.0922 8.68981 -479 2 9.89359 5.91802 15.1417 7.60675 -24.7177 2.15595 -480 2 10.032 6.8882 13.9194 5.10262 -3.22926 -9.37061 -481 1 15.2334 4.35765 10.7756 -27.5978 -16.2477 -22.3588 -482 2 16.1684 4.22394 10.6591 16.9939 1.30069 13.5789 -483 2 15.041 5.04225 11.4098 10.4595 11.1452 11.1309 -484 1 11.214 6.13659 0.181715 -19.0514 -14.6776 -12.5318 -485 2 11.2124 5.17659 0.0304417 14.0569 6.29109 5.62342 -486 2 10.2823 6.34718 18.6411 6.7491 10.3457 6.1137 -487 1 0.148583 11.3373 15.1258 -19.5821 15.0001 -24.2151 -488 2 18.1981 11.6758 14.382 16.6378 -5.64999 24.2973 -489 2 18.7581 12.0391 15.8029 -7.9684 -6.15355 -5.02438 -490 1 7.07881 9.17505 7.27008 -6.43803 -1.74166 -4.58486 -491 2 6.45798 8.45812 7.48524 7.10939 3.15379 4.24177 -492 2 7.95401 8.76045 7.26417 -3.66954 2.28396 2.09633 -493 1 18.4168 15.4276 12.3546 -3.43386 -0.549873 -4.48624 -494 2 0.729474 15.5504 12.2627 0.527014 -4.05801 2.94094 -495 2 18.0745 15.7474 11.5108 -2.98934 0.409485 0.218187 -496 1 16.554 4.36499 5.23729 20.8954 -6.05263 25.9175 -497 2 16.7683 4.14077 6.16822 -16.8827 1.59137 -12.628 -498 2 17.4495 4.42836 4.87212 -5.6372 6.04853 -15.3532 -499 1 17.7678 3.07292 10.7257 -2.33819 12.1961 -2.64827 -500 2 0.05876 3.27172 10.9273 -5.50289 -7.01135 -0.383438 -501 2 17.6798 2.21428 10.2822 5.02163 -0.151153 2.81987 -502 1 12.2925 0.0394171 10.1485 -5.03026 26.5344 11.6637 -503 2 11.4572 0.407352 10.526 9.87088 -12.259 -12.5756 -504 2 12.9102 0.803778 10.1803 -6.63246 -15.2789 0.0865208 -505 1 10.3587 9.80679 12.3603 15.6128 10.3756 0.750657 -506 2 11.1656 9.89562 12.9016 -9.14674 -1.49827 1.04164 -507 2 10.2822 8.8615 12.2126 -4.78815 -8.04326 1.85351 -508 1 0.512396 2.83902 7.01376 3.84696 0.0782361 15.1378 -509 2 0.640445 3.53836 7.66576 0.959953 5.26089 -8.6545 -510 2 0.680944 2.06786 7.56376 2.06531 -6.50055 -6.8896 -511 1 0.435055 15.2675 6.92024 15.2549 -35.398 4.87844 -512 2 0.621058 15.2814 7.87767 -6.30652 4.63478 -5.55491 -513 2 0.767833 14.3496 6.68755 -16.1257 30.2961 -2.9732 -514 1 16.9932 7.01767 15.3053 -26.5651 1.45521 -6.17716 -515 2 17.7481 7.60304 15.1777 11.1425 -6.61607 -1.97906 -516 2 17.2478 6.0923 15.4082 16.5215 2.79636 5.68328 -517 1 9.018 12.4253 8.12635 6.95093 19.302 15.9025 -518 2 9.42759 11.8305 7.48541 -10.9396 -6.20971 -13.8418 -519 2 8.05723 12.5431 8.02215 9.94353 -10.4145 -8.12359 -520 1 1.2603 1.92339 3.03777 4.00037 -11.2111 -0.333139 -521 2 0.985763 2.4239 2.25859 3.27899 1.87382 4.37683 -522 2 1.94434 2.40743 3.53125 -8.95634 4.24445 -6.71947 -523 1 4.13152 15.1081 9.6737 -15.9579 5.42681 13.2475 -524 2 4.06185 15.276 8.72578 6.37214 -2.02945 -0.454299 -525 2 5.01049 14.775 9.87491 6.77649 -3.08542 -5.82222 -526 1 7.18656 2.18024 14.5742 6.63684 0.423238 1.66106 -527 2 6.97291 1.78224 13.7284 -0.102066 -5.66692 0.745345 -528 2 7.71431 2.94579 14.3335 0.160548 4.26015 2.86325 -529 1 18.6004 14.6938 2.16823 2.76542 -5.02319 -0.780568 -530 2 0.802927 15.1539 2.18876 5.80577 -4.93168 -0.456722 -531 2 17.9585 15.3989 2.13554 -15.1748 6.08707 3.47143 -532 1 9.94779 2.77101 12.9402 13.7079 -4.8088 0.992354 -533 2 9.86912 2.18708 12.1681 -6.43941 0.85112 1.08944 -534 2 9.26112 3.44421 12.9098 -9.63803 -0.00730006 -3.05418 -535 1 2.82654 8.93218 13.0337 -16.8853 -9.00607 0.122573 -536 2 3.25687 9.752 12.7946 6.59476 15.835 -2.70012 -537 2 3.50997 8.32082 13.3007 12.5319 -6.06263 8.37491 -538 1 3.22862 8.37837 3.65188 -0.226515 1.69475 29.0088 -539 2 3.688 9.03214 3.10752 1.26352 6.15003 5.24259 -540 2 3.37942 8.56962 4.62044 0.873457 0.138782 -29.442 -541 1 5.6209 7.19208 8.52428 9.74274 9.28918 -7.76376 -542 2 5.82768 6.24803 8.58864 -11.1579 -1.95789 2.42461 -543 2 4.98617 7.45468 9.2041 -0.288223 -8.23268 4.91577 -544 1 14.8711 1.29057 2.00464 8.31119 17.2873 -6.28041 -545 2 14.835 2.11415 2.48745 -9.33397 1.40045 17.6104 -546 2 15.2356 1.62076 1.17953 -0.998754 -14.9614 -12.238 -547 1 8.25883 15.2026 0.830681 5.29747 -5.49957 9.6471 -548 2 8.95156 15.1522 1.50066 13.8019 -1.55539 -6.59484 -549 2 7.5748 14.6468 1.22478 -8.81297 0.605757 -6.77665 -550 1 15.6232 1.34362 7.23598 -18.647 -1.91314 -11.6656 -551 2 14.9897 0.764646 6.76092 12.0508 5.58891 7.1025 -552 2 15.1447 2.18632 7.33027 3.5178 -4.19741 5.22167 -553 1 4.94904 13.0769 18.5237 9.6722 0.589191 0.374268 -554 2 5.36668 13.208 0.749415 -4.04426 -2.7658 -6.21312 -555 2 5.63686 13.3362 17.8955 -3.04446 1.7017 1.4528 -556 1 15.3696 8.47999 18.1528 -1.21138 17.1653 -12.6794 -557 2 15.695 9.10606 17.469 -1.13375 -12.9806 6.06144 -558 2 15.1122 9.07709 0.225504 3.72099 -3.98362 5.25331 -559 1 12.0892 3.03182 18.3639 -14.1234 30.4246 -7.06661 -560 2 12.0418 2.65673 0.600248 11.0312 -14.2758 -1.1161 -561 2 12.4684 2.43863 17.7097 5.58993 -13.4699 6.64437 -562 1 13.2076 12.6677 5.18878 -11.1257 12.6934 -18.8931 -563 2 13.6382 11.873 4.85103 6.50507 -2.50005 7.23376 -564 2 13.4408 12.7972 6.11334 1.90386 -8.97209 5.02297 -565 1 6.04179 7.07685 0.0416979 2.64097 -12.2137 0.441028 -566 2 5.97681 7.98433 18.9573 -0.86164 23.926 -2.06041 -567 2 5.22747 6.68409 0.369779 -2.28588 -4.24693 2.31783 -568 1 17.7316 15.9939 15.0114 -15.9363 1.83518 -2.01139 -569 2 16.8954 16.4456 15.035 -7.98632 8.38962 22.0218 -570 2 17.7728 15.8943 14.0703 21.4922 -14.9825 -23.1623 -571 1 13.1856 0.993654 16.5812 4.51688 -6.04585 -7.39508 -572 2 14.1484 0.841574 16.6066 -7.22778 -1.30407 6.3933 -573 2 12.7998 0.141541 16.3207 3.39554 1.08214 8.76474 -574 1 11.0918 14.5789 7.23122 -0.0827639 9.53574 4.16562 -575 2 10.4295 14.1218 7.74457 -13.7426 -4.81361 3.6986 -576 2 11.9118 14.1808 7.52276 7.59678 -9.08814 -4.3045 -577 1 17.5016 8.6119 2.09076 15.8147 11.2146 7.10458 -578 2 16.6678 8.4072 2.52184 -8.49554 -5.1851 -0.954934 -579 2 17.6089 8.02126 1.34907 -7.08963 -15.2245 -7.94382 -580 1 12.3468 7.97644 1.98939 8.16003 1.60059 13.0036 -581 2 12.1059 8.91014 1.92161 -4.12319 -5.14517 -8.91961 -582 2 11.9653 7.48445 1.25112 -3.43761 0.267259 -0.201848 -583 1 11.9018 14.6174 10.3415 -1.61415 6.01794 0.545715 -584 2 12.1103 13.7968 9.87035 -7.85836 7.68399 3.13223 -585 2 10.9576 14.8558 10.2015 13.8599 -12.9225 1.87067 -586 1 6.88302 7.0351 15.5985 0.0361083 -3.88964 -3.36213 -587 2 7.78537 7.14813 15.233 -9.24764 2.66089 10.2853 -588 2 6.74206 7.63616 16.3488 6.91006 -2.15529 -8.72434 -589 1 7.99721 4.71198 13.4628 5.66523 -8.00363 0.660216 -590 2 7.27921 4.81457 12.8289 -1.54019 0.966988 -4.0678 -591 2 8.48375 5.53924 13.4635 -1.88422 3.21799 -0.709238 -592 1 13.4036 12.1691 14.2716 3.14721 5.94494 7.46154 -593 2 13.2707 11.2057 14.207 -2.45791 4.15826 -3.3873 -594 2 13.8696 12.4652 13.4742 -1.1423 -6.74147 -2.23487 -595 1 14.8179 9.43426 7.29668 -6.36233 -11.9657 -8.30628 -596 2 15.5946 9.98871 7.43973 -1.00608 2.08043 5.84882 -597 2 14.0417 9.81939 7.70717 2.29675 7.38462 3.05591 -598 1 12.6631 17.0342 3.08686 -0.647851 26.0284 13.2632 -599 2 13.0189 17.4392 3.9047 -6.62985 -13.126 -8.67274 -600 2 12.0984 17.7464 2.72355 6.77056 -16.0012 0.625123 -601 1 1.16659 7.14982 17.4488 -22.2539 0.168591 -14.6305 -602 2 0.289944 6.86023 17.7803 4.99818 12.4666 0.0121858 -603 2 0.976074 7.62854 16.6106 6.60301 -8.93429 9.27073 -604 1 12.7913 5.13723 15.6659 26.8924 -5.83385 4.65231 -605 2 13.5397 4.50448 15.7352 -14.8898 5.20509 -1.35689 -606 2 13.2524 6.00122 15.6738 -9.3883 -7.24139 -3.09335 -607 1 2.50717 3.39641 5.02544 -4.94238 4.99772 43.075 -608 2 1.86502 3.10611 5.74586 16.3729 8.7954 -24.7542 -609 2 3.07143 4.08677 5.47722 -17.3542 -15.0389 -19.8763 -610 1 8.33721 11.2536 13.4671 -31.8218 12.3906 11.8554 -611 2 8.27902 11.0779 14.4347 20.4393 -8.01279 -19.4916 -612 2 9.11607 10.9377 12.9927 6.53682 -12.2231 14.6875 -613 1 12.8982 1.36842 13.3393 -2.38428 13.9081 -24.9925 -614 2 13.3657 1.32357 12.4816 4.13856 -5.14841 14.3736 -615 2 12.4149 2.20238 13.2267 1.28817 -6.58848 11.7421 -616 1 6.36101 13.6632 2.13728 5.84509 3.64922 20.165 -617 2 5.80267 14.0802 2.81815 -1.42815 -2.61112 -9.48922 -618 2 6.96781 13.1347 2.6793 2.58248 -4.73497 -8.11447 -619 1 15.9275 6.58906 12.776 -13.2255 -11.9143 -7.63467 -620 2 16.5079 7.05171 12.1721 3.66176 7.36442 -5.52267 -621 2 16.2877 6.70509 13.653 8.87525 3.50761 9.55012 -622 1 16.8403 0.7053 9.59425 -10.8287 -6.51914 0.180126 -623 2 16.6786 18.4058 9.8215 7.5744 10.512 -7.34073 -624 2 16.3431 0.86575 8.76743 6.96547 -2.88011 1.97602 -625 1 6.14042 11.7236 8.37935 -13.4401 -40.1875 -12.4491 -626 2 5.21965 11.5178 8.67227 17.9013 7.59491 -1.88002 -627 2 6.47134 10.8481 8.01351 -3.81201 28.7474 13.2691 -628 1 2.85976 8.65216 0.41009 29.1416 -12.2873 -0.261225 -629 2 2.35956 8.19684 18.3517 -12.3126 13.3733 12.5274 -630 2 2.40304 9.34487 0.902258 -18.8466 -1.4582 -10.1697 -631 1 10.1473 10.4614 6.51315 3.14709 -2.48115 -1.63688 -632 2 10.5898 9.76783 7.02035 -1.8228 -0.602608 0.477386 -633 2 10.6086 10.4674 5.65949 -3.20151 3.83187 3.87642 -634 1 6.7508 15.7003 6.55579 -3.66232 16.9823 8.74149 -635 2 7.17195 16.1106 7.3235 -0.889674 -7.99055 3.10182 -636 2 6.78205 16.4211 5.90999 7.33374 -8.97986 -9.58603 -637 1 6.44532 13.1371 5.60194 -4.00449 -9.15456 -0.382904 -638 2 6.60496 14.011 5.98141 3.67218 -1.64471 2.17047 -639 2 6.02503 12.5975 6.28414 2.5909 4.19611 1.89612 -640 1 16.8064 12.5561 9.82402 0.581653 -6.91502 5.14494 -641 2 16.9779 11.8749 9.14515 -1.61791 10.9714 -1.54419 -642 2 16.8208 13.4318 9.41997 2.06437 -4.78596 -5.13994 -643 1 6.05928 2.9442 2.82556 1.25802 -7.30262 2.82421 -644 2 6.27309 3.83898 2.57954 7.79966 17.9541 1.71249 -645 2 5.71238 2.57735 2.0082 -4.75947 -10.8151 -3.84195 -646 1 10.8984 3.29285 3.29228 5.15622 -3.79068 5.20633 -647 2 10.3299 4.01236 3.59418 -0.748764 -1.25701 -6.51467 -648 2 10.5397 2.95527 2.46424 -5.70132 0.188995 -0.608043 -ITEM: TIMESTEP -30 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.74009 7.04233 17.938 19.1777 -3.19214 -7.49225 -2 2 7.80649 7.00854 18.1244 -14.093 -2.50808 3.42214 -3 2 8.91581 6.41795 17.2214 -5.10918 0.448792 4.2696 -4 1 18.6171 8.27942 6.83462 -12.32 14.9255 -3.46236 -5 2 0.0642234 8.14825 5.88022 8.8384 -8.96826 -1.74433 -6 2 0.471057 7.61284 7.31078 8.78566 -8.6497 2.36561 -7 1 8.41948 18.604 6.83196 -7.31709 9.89495 0.0475112 -8 2 9.31705 0.18142 6.57583 5.64527 1.22556 -0.782264 -9 2 7.87491 0.677395 6.4693 3.49499 -4.79599 0.294282 -10 1 6.58709 1.81441 11.6738 -9.76955 10.2882 13.9968 -11 2 5.91112 2.25954 12.2323 7.89399 -9.20897 -13.0604 -12 2 6.23103 0.933026 11.5157 -4.21921 -5.78552 -0.720022 -13 1 7.09426 5.71845 2.37594 5.34919 -15.1759 8.94595 -14 2 6.67772 6.26147 3.06365 -7.93287 1.62685 -13.8275 -15 2 6.91151 6.0744 1.49958 -5.30903 10.9181 0.766926 -16 1 16.2033 10.1932 16.1102 25.1038 -14.8345 -4.68499 -17 2 17.1811 10.2276 15.9712 -26.7737 6.31541 3.48142 -18 2 15.8826 11.0697 16.3304 -0.495148 7.87416 1.92317 -19 1 10.6275 14.9681 2.33481 4.63974 12.4061 -8.88569 -20 2 10.5525 14.5877 3.21874 0.475518 -3.93386 2.29786 -21 2 11.1735 15.7673 2.45016 -5.17002 -7.496 3.37274 -22 1 17.1558 8.25893 10.4932 -6.40301 -0.466841 8.61163 -23 2 16.8014 9.01233 11.0035 2.41501 -9.01393 -1.96838 -24 2 17.9838 8.5563 10.1014 3.2569 5.37409 0.738347 -25 1 14.813 15.8567 16.3841 0.422148 6.97991 -3.34819 -26 2 13.9021 16.1825 16.382 -1.86689 -1.60487 0.125842 -27 2 14.9304 15.3999 17.2268 -3.27081 -1.81494 5.72738 -28 1 12.1434 13.4089 0.461034 6.76243 -11.3039 1.90058 -29 2 12.0273 13.3364 18.1404 -4.47443 10.9984 5.76772 -30 2 11.5266 14.0334 0.870976 -2.78837 -1.53089 -3.65161 -31 1 9.27697 5.43199 4.02458 -7.91052 -7.29997 -7.2337 -32 2 8.84655 5.10212 4.83549 0.848683 4.58319 -8.36746 -33 2 8.59135 5.35221 3.31849 12.3251 4.32217 11.9863 -34 1 1.81829 4.21991 11.6429 6.07059 -17.107 12.3126 -35 2 1.72876 5.16246 11.8251 -3.56412 5.27463 0.970751 -36 2 2.25117 3.81723 12.4298 -6.51129 5.35444 -16.475 -37 1 2.00161 6.82001 8.34658 4.25884 -4.64897 6.26816 -38 2 2.3883 7.2423 9.12712 0.123274 4.2764 -6.11357 -39 2 2.06217 5.87963 8.57415 -6.89287 0.824976 -4.38383 -40 1 5.40511 4.42179 7.95561 5.36611 -11.1614 7.9457 -41 2 5.37943 3.4545 8.00651 8.07147 0.734095 -1.60012 -42 2 4.74745 4.62621 7.29567 -7.31573 12.7226 -8.35968 -43 1 3.27976 2.92717 17.5269 -2.61436 17.3567 -5.43199 -44 2 3.96706 3.40529 17.0145 -5.77518 -10.9103 1.73426 -45 2 2.73687 3.63363 17.9263 6.62302 -5.15647 1.61932 -46 1 7.46558 5.28438 6.08942 -8.18758 20.8516 25.3808 -47 2 7.86532 6.07017 6.49581 9.60667 -5.12281 -7.79846 -48 2 6.93507 4.98822 6.84771 -4.13165 -15.5457 -12.384 -49 1 9.77734 7.00329 11.9774 4.77277 1.25087 12.6605 -50 2 10.3838 6.43919 11.4894 -2.2356 -0.795019 -4.50196 -51 2 9.03042 7.20515 11.401 -0.391647 0.322053 -6.58611 -52 1 14.0794 3.58589 8.07965 12.1281 -3.68665 15.0324 -53 2 13.9224 4.24013 7.41233 -5.94016 13.6931 -8.832 -54 2 14.4997 4.05823 8.8235 -7.49262 -7.6028 -6.06268 -55 1 4.66909 17.2524 3.98463 -11.974 -6.63251 3.44703 -56 2 5.54996 17.5659 4.2137 3.76078 6.9996 -9.15965 -57 2 4.29017 17.6906 3.19701 6.52868 -0.394456 6.67531 -58 1 16.4992 16.6027 10.1206 -21.6924 9.71885 22.6747 -59 2 15.7868 16.8403 10.7484 14.9981 -6.02669 -3.77625 -60 2 16.0155 16.0666 9.49209 1.7904 -6.99745 -11.6514 -61 1 1.97502 4.88502 0.412911 -0.608987 3.87721 -1.07962 -62 2 2.72637 5.27959 0.897705 -7.05745 -2.41863 1.64934 -63 2 1.49341 5.65258 18.7073 9.30006 -4.776 -0.647009 -64 1 11.7125 13.3331 16.298 -5.19121 -16.9939 -9.12414 -65 2 11.2215 12.495 16.3147 -7.17559 5.00423 10.7559 -66 2 12.3053 13.159 15.554 3.20757 8.82206 0.62976 -67 1 10.1364 11.0457 16.9267 -8.25027 -0.64471 -2.79768 -68 2 10.5138 10.1546 16.8726 -0.811727 0.343111 1.84422 -69 2 9.16904 10.9405 16.8614 10.4447 -1.98124 -2.23602 -70 1 11.7196 17.4866 13.4532 0.688277 4.88805 11.3616 -71 2 12.4565 17.1915 12.9059 2.31052 0.20251 -3.63622 -72 2 11.8417 18.4468 13.5823 3.75325 -8.25615 -8.02045 -73 1 6.38436 9.31353 12.2227 -10.6166 9.98881 15.1897 -74 2 6.82973 8.96514 11.4526 14.2312 0.227315 -7.303 -75 2 6.92633 10.0292 12.607 -0.115112 -8.7725 -6.80594 -76 1 16.2215 12.7689 2.69197 14.2202 2.36446 -2.70282 -77 2 17.0315 13.2181 2.42332 4.27042 -4.81366 0.268886 -78 2 15.6299 13.4985 2.86911 -16.5638 6.55953 0.86202 -79 1 0.643858 12.5819 5.90471 10.4355 0.0636689 -1.96923 -80 2 0.972356 12.3928 5.01972 -0.601341 2.21783 -2.79245 -81 2 18.3387 12.6591 5.78833 -5.81166 2.35718 1.0682 -82 1 5.2154 16.4273 18.4533 5.05017 -7.28804 7.26993 -83 2 5.85096 15.759 18.1791 -0.38035 -3.88529 -12.2081 -84 2 5.53459 16.6741 0.678671 -3.42073 7.449 3.19712 -85 1 0.551654 7.64481 4.10641 16.2354 21.1246 -10.5626 -86 2 18.6183 7.98546 3.39603 3.07966 -1.83327 6.1622 -87 2 1.42708 8.08449 3.93576 -19.267 -16.5837 1.18512 -88 1 3.12227 8.91534 6.50802 24.2291 -0.585626 7.1452 -89 2 3.7382 8.63748 7.22391 -17.1573 3.17125 -13.7643 -90 2 2.22482 8.81583 6.82729 -5.68465 -1.73896 5.22193 -91 1 7.30086 10.3189 16.2323 -15.6545 -0.122126 6.34207 -92 2 6.59019 10.5178 15.6183 5.33711 0.792532 -4.64 -93 2 6.81196 10.2023 17.0683 9.00195 1.1125 -0.831229 -94 1 11.1139 1.03369 5.01342 4.3303 1.68398 -12.6705 -95 2 11.3068 1.80352 4.46111 -2.07011 7.18197 9.97137 -96 2 10.7762 0.428462 4.34613 -4.44642 -9.51924 3.00218 -97 1 4.39584 2.7383 13.2149 -0.390466 4.89753 -17.2666 -98 2 4.70663 3.24132 13.9776 -1.24631 -10.9908 10.3904 -99 2 4.24133 1.79775 13.4334 4.65854 7.0575 9.14841 -100 1 8.38523 10.0971 1.80824 -1.28714 19.1329 -0.644156 -101 2 8.30354 10.8052 2.48172 0.822207 -7.93375 -7.37013 -102 2 8.79223 9.36658 2.27287 1.71369 -9.23717 4.71722 -103 1 10.4729 1.73916 15.5717 11.6995 -6.53653 -13.4069 -104 2 11.3877 1.45477 15.4183 -5.50109 4.13915 12.9036 -105 2 10.2466 2.11684 14.7151 -9.31794 0.949785 -3.28817 -106 1 2.72932 12.8923 7.77007 2.13638 -2.03638 4.95693 -107 2 3.24355 13.6603 7.47881 -3.48119 -3.6232 -2.9431 -108 2 2.14523 12.6528 7.03806 -2.13852 4.70731 1.87174 -109 1 3.67999 11.6951 5.25129 1.06179 2.30609 -7.65488 -110 2 3.48397 10.8814 5.71277 1.07183 -5.39866 6.20843 -111 2 2.98047 11.7882 4.59744 -0.426908 3.81831 -2.62473 -112 1 6.82829 14.472 16.8976 7.24547 -11.7087 -0.510459 -113 2 7.70535 14.0752 16.845 -3.98439 5.03843 1.85271 -114 2 6.50852 14.4918 15.986 -3.30226 9.38599 0.302494 -115 1 14.1912 14.5549 3.37889 -4.65321 -1.5346 -2.40618 -116 2 13.6567 15.3531 3.27958 4.16996 -0.562804 -5.50008 -117 2 13.6356 13.9417 3.87468 5.16163 -0.564442 6.07906 -118 1 8.32326 18.1549 16.0383 38.0123 0.723105 5.33509 -119 2 8.90126 17.4596 16.3629 -14.277 -18.5473 4.85232 -120 2 9.02384 0.130446 15.7883 -15.867 17.9211 -5.43461 -121 1 4.72767 1.62379 4.93271 -17.6379 -0.985038 1.9521 -122 2 3.81401 1.95679 4.84992 11.4813 -1.52324 3.97162 -123 2 5.23321 2.13073 4.30096 3.99283 5.81443 -10.8958 -124 1 15.0185 12.7583 16.4307 33.5549 -15.7429 -8.88385 -125 2 14.6322 13.2399 17.156 -17.5625 6.9837 5.99474 -126 2 14.4538 12.6352 15.6516 -10.3238 6.55553 8.00439 -127 1 15.7718 18.4254 16.841 -12.0797 -5.1952 -2.21012 -128 2 16.3284 18.515 17.6327 0.946096 -4.9786 -5.09166 -129 2 15.4084 17.517 16.8347 11.7053 8.22526 2.07191 -130 1 1.18057 1.17309 16.5558 11.0398 2.91722 -0.500753 -131 2 1.84524 1.84688 16.7601 6.86303 -5.43895 -3.7977 -132 2 0.618264 1.22767 17.321 -11.8887 1.06625 6.89733 -133 1 18.1125 4.54155 15.913 0.560198 2.18648 6.37111 -134 2 18.4591 4.08913 15.1466 2.75843 -6.08521 -5.17788 -135 2 18.7597 4.4472 16.6204 -1.36812 0.49592 -3.69459 -136 1 12.2402 16.9779 16.1352 2.31512 -6.99762 -15.3414 -137 2 11.5952 16.4515 16.6081 -8.3163 0.999648 8.5775 -138 2 12.0081 16.8315 15.1982 2.22798 9.47321 6.13039 -139 1 15.9623 2.53119 18.0207 2.93621 -4.28086 -0.122131 -140 2 15.5695 3.22825 18.5544 -2.43998 7.63429 -5.2422 -141 2 15.6676 2.68289 17.1026 2.19807 1.36349 7.25858 -142 1 6.70368 13.8359 10.2288 1.24588 -18.109 -1.49583 -143 2 6.57782 13.5214 11.1319 -1.51171 6.96132 4.85856 -144 2 6.68827 13.0063 9.72453 -2.19505 9.55036 -5.72862 -145 1 10.1309 18.2871 2.76796 -14.3596 -6.47533 0.342864 -146 2 10.2029 0.342366 2.11266 2.51428 7.52943 -3.11917 -147 2 9.22516 17.9366 2.63576 15.7336 3.88756 2.50188 -148 1 2.99532 17.7363 6.09725 27.6457 -0.367768 9.57951 -149 2 2.17297 17.7876 5.61616 -10.9588 -3.8104 -13.5012 -150 2 3.724 17.7747 5.44639 -16.7072 2.57282 0.579206 -151 1 12.5761 16.9143 8.00615 -13.9856 15.3012 3.95273 -152 2 11.7456 16.4539 7.8426 4.73348 -10.9119 -5.17088 -153 2 12.3021 17.5765 8.66814 13.2598 -3.61726 -0.932189 -154 1 14.882 15.2803 8.24971 10.681 -0.761738 -5.80123 -155 2 14.3225 16.029 8.07669 -22.8014 8.12514 9.31404 -156 2 15.4227 15.298 7.45407 7.11517 -7.78554 -3.15381 -157 1 17.6329 18.2578 0.365715 -0.853361 22.9802 4.00517 -158 2 18.5235 17.9699 0.161776 5.93848 -16.2402 -3.481 -159 2 17.7627 0.512218 0.708086 -5.13428 -6.58263 -1.39758 -160 1 0.88251 10.4012 1.38524 10.7451 13.2218 -5.20703 -161 2 0.0659506 9.93794 1.52098 -14.8693 -14.1338 10.0664 -162 2 0.630973 11.1288 0.804044 1.28572 5.25949 -2.19783 -163 1 1.64115 12.2217 3.35193 -3.18006 -13.1055 -18.8251 -164 2 1.37082 11.5062 2.75067 2.88651 -5.3868 11.6868 -165 2 1.67765 12.9428 2.72371 4.09986 15.3051 6.03005 -166 1 0.58147 17.2398 4.87485 -10.389 -0.219728 20.623 -167 2 -0.122589 17.8866 4.86961 1.40048 11.6397 -9.93657 -168 2 0.410626 16.8027 5.7206 11.49 -10.3372 -7.14723 -169 1 1.11352 0.964392 9.43077 -4.94184 3.64088 -20.8453 -170 2 1.20387 0.588778 10.3126 -0.847456 -3.79009 5.67247 -171 2 0.226103 0.72639 9.1141 8.25621 -1.04795 9.52173 -172 1 16.7603 2.33922 13.2874 -3.33679 -13.7714 7.5216 -173 2 16.8475 2.59005 12.3669 3.49604 3.27514 -7.50745 -174 2 16.539 1.38388 13.2956 1.74648 12.4468 1.52133 -175 1 2.56382 15.8252 12.169 -1.32309 5.18512 -19.2115 -176 2 3.14843 15.408 12.7949 3.95332 -3.2625 9.96296 -177 2 3.02181 15.7534 11.31 -3.03818 -3.40517 4.91625 -178 1 16.4251 15.6276 5.98753 2.75225 -2.61515 5.58966 -179 2 17.3447 15.6415 6.33695 -10.8386 4.94036 -7.12539 -180 2 16.2312 16.4474 5.48017 12.4296 -10.8984 6.26847 -181 1 5.80144 5.06794 11.7894 5.49032 -3.99323 1.93812 -182 2 5.42192 5.63452 12.4754 -2.65214 7.25607 -4.62846 -183 2 5.38258 4.20716 11.9011 -4.64894 2.39601 -1.00669 -184 1 15.1781 4.86184 0.728524 -4.34825 6.76152 14.6306 -185 2 15.2668 4.67158 1.68153 -8.60174 -1.32446 -9.75027 -186 2 14.3367 5.34751 19.2902 10.4034 -8.61994 -3.37533 -187 1 16.3306 16.3549 2.10387 -3.60874 -8.17165 19.4202 -188 2 16.1436 16.7757 2.96383 0.821724 -8.86269 -6.10473 -189 2 16.4161 17.1032 1.53428 7.22132 12.8567 -17.8694 -190 1 0.267773 4.86229 3.80408 10.7738 -14.2237 3.39069 -191 2 0.48911 5.8014 3.76313 1.80944 1.44211 5.87769 -192 2 1.0394 4.38382 4.18029 -13.1099 14.4171 -4.44332 -193 1 2.95694 15.0447 15.0954 -6.10325 -16.3486 9.96696 -194 2 2.71126 14.628 15.9563 6.59243 11.9398 -10.1751 -195 2 2.48371 15.8886 15.0723 0.827451 0.569437 4.39106 -196 1 1.13642 14.6155 9.54099 -48.9591 -6.29818 10.1377 -197 2 2.0574 14.6763 9.37448 31.1561 -9.052 1.81392 -198 2 0.917533 13.7788 10.0133 17.9146 13.2649 -10.59 -199 1 13.6267 16.618 11.5309 -14.0517 -2.94194 4.54584 -200 2 13.2284 17.3872 11.0909 1.36391 -4.96948 -3.72009 -201 2 13.0435 15.8681 11.2876 10.4622 6.11411 -5.34277 -202 1 4.69594 1.47637 0.748111 -12.1621 -0.739309 -0.414133 -203 2 4.0907 2.00679 0.20438 8.77888 0.173625 -0.66482 -204 2 4.10511 0.858084 1.19895 3.99089 -4.2391 -0.703649 -205 1 1.43799 18.5334 11.8677 4.48354 -19.5441 -2.70285 -206 2 1.28309 0.34807 12.6964 -2.38454 7.77338 6.6957 -207 2 1.65634 17.6099 12.1011 0.514199 12.3996 -0.852918 -208 1 11.5339 10.1172 4.0507 5.82948 9.6286 -18.4863 -209 2 11.2843 10.5321 3.18756 5.15824 -8.38498 16.2271 -210 2 12.5124 10.093 4.04255 -10.5657 0.881913 4.0585 -211 1 8.32129 12.1582 3.72502 1.53352 8.77417 8.44763 -212 2 9.09494 12.6645 4.01218 5.78128 -3.64141 -7.92941 -213 2 7.76311 12.2518 4.50437 -12.3191 -3.17133 -0.801295 -214 1 14.3738 4.02512 3.28302 13.4457 8.56362 13.3606 -215 2 15.0833 4.15474 3.94873 -8.39321 -4.82495 -4.85792 -216 2 13.6328 4.57269 3.59478 1.91801 -3.79011 -4.78214 -217 1 5.59001 1.69403 7.5104 -22.1497 -9.71937 -16.3739 -218 2 4.92965 1.04535 7.86703 17.0022 15.2682 -3.23125 -219 2 5.33019 1.76513 6.54994 10.6546 -4.2597 24.8978 -220 1 17.8762 1.11593 4.87562 6.9502 3.59021 1.61777 -221 2 18.6375 1.36949 4.33979 -2.23157 -1.53514 -7.48501 -222 2 17.9489 1.70322 5.63717 -7.55192 -1.12522 1.72169 -223 1 6.82082 9.41417 4.48467 7.28036 -1.61815 9.25922 -224 2 6.87733 9.61398 5.42883 -5.7945 0.587378 -0.0554941 -225 2 7.74179 9.22243 4.26363 -0.0627487 -3.5933 -6.80471 -226 1 2.67079 14.9403 1.9639 10.8093 -10.5544 22.1131 -227 2 3.25117 14.6591 2.70117 -12.0207 4.93014 -5.95014 -228 2 3.29732 15.1077 1.27121 3.13815 4.27624 -15.5237 -229 1 17.3067 12.913 13.1683 10.6019 -31.6629 4.62367 -230 2 16.4497 13.2737 13.3972 -3.78483 16.2252 -3.80314 -231 2 17.8834 13.5891 12.8053 -8.28955 15.595 1.58636 -232 1 14.9867 10.5664 1.39303 17.3246 -3.28745 6.09509 -233 2 15.5958 11.2392 1.752 -7.58668 -4.78908 -2.0363 -234 2 14.1528 11.003 1.29225 -13.717 8.26159 -1.38466 -235 1 5.69708 6.86241 4.54741 10.2551 2.99419 0.383868 -236 2 6.12873 7.74081 4.58523 -8.39477 -7.3362 -0.690872 -237 2 6.29159 6.23392 4.98874 0.140081 3.89587 3.34658 -238 1 8.04621 8.27418 10.2318 -1.25624 6.00125 -7.48209 -239 2 8.67166 8.94213 9.92965 6.80147 7.39227 7.14523 -240 2 7.62794 8.03247 9.40376 -7.32264 -11.607 2.12748 -241 1 13.4746 18.3625 5.78211 -13.502 7.51331 -2.26288 -242 2 12.7551 0.364455 5.61988 6.67968 -8.24018 -2.37745 -243 2 13.1168 17.8207 6.50434 6.50164 -0.829271 0.111391 -244 1 0.226362 2.58719 0.131375 -15.5932 24.0028 11.6326 -245 2 17.9693 2.93929 18.6394 3.5786 -16.3529 -5.12341 -246 2 0.708035 3.3711 0.44675 7.58398 -8.21165 -4.7522 -247 1 12.703 11.0237 9.75181 24.9284 -7.65781 8.94422 -248 2 11.7937 10.9936 9.46616 -11.7502 -8.38149 -1.23796 -249 2 12.9608 10.1029 9.99094 -10.5021 9.57622 -2.72207 -250 1 0.761974 12.2205 11.0816 -4.15363 -6.09516 -21.355 -251 2 18.4366 12.288 11.0674 3.38909 -0.754442 8.49561 -252 2 1.11175 12.4338 11.9478 -3.68194 5.91832 8.04416 -253 1 5.07253 7.26896 13.4467 3.90397 -0.0234352 3.77117 -254 2 5.61152 7.96046 13.0436 -1.11485 3.21213 -6.58832 -255 2 5.53238 7.13074 14.2827 -1.05457 -4.33313 3.81413 -256 1 1.23629 6.9109 11.8337 28.2892 12.95 23.6673 -257 2 0.51347 7.34016 11.3984 -13.736 7.24235 -8.87687 -258 2 1.75935 7.64669 12.2495 -13.9201 -17.9067 -15.9983 -259 1 15.4873 9.53008 12.3182 -0.383493 4.12812 -8.89679 -260 2 15.0655 10.399 12.2152 3.51435 -2.6855 7.45914 -261 2 15.2649 9.14784 13.1724 -1.90612 6.52608 2.19385 -262 1 16.6085 12.8345 5.46896 -3.55761 11.1023 -1.95777 -263 2 16.4419 13.7896 5.48874 0.313493 -0.193839 12.6146 -264 2 16.4475 12.6632 4.54137 -0.0496347 -14.7353 -8.15109 -265 1 6.20534 9.98194 0.0899104 18.0768 -8.37359 0.258846 -266 2 5.59572 10.4068 0.70246 -2.59094 3.74961 3.89273 -267 2 7.08249 9.9872 0.527613 -14.0474 2.02387 3.58276 -268 1 12.3397 6.07843 4.05984 1.81271 11.939 -8.21694 -269 2 12.2328 6.8085 3.41842 8.48996 -4.45606 3.14495 -270 2 11.4615 5.7138 4.10837 -10.8447 -6.35959 3.05037 -271 1 0.186481 12.7968 0.194157 8.45417 -0.362633 0.823389 -272 2 0.122538 13.4857 0.868002 -3.08717 1.48078 1.57348 -273 2 18.4164 13.184 18.057 -2.66731 -2.48236 -4.34426 -274 1 3.77162 18.5917 8.57827 -20.4554 1.45559 2.68175 -275 2 3.52322 17.9715 7.87805 6.33007 3.25639 -1.82086 -276 2 2.90938 0.367014 8.76804 7.74592 -0.0744794 5.639 -277 1 7.46409 17.2961 4.48316 -14.1198 -17.2275 8.02552 -278 2 7.88946 18.1398 4.59819 4.06261 16.9953 -5.43573 -279 2 7.32948 17.1504 3.54137 6.62361 8.1702 -3.03871 -280 1 9.24056 17.0796 12.2607 -1.29913 -0.841935 -6.42698 -281 2 9.19718 16.4258 11.5387 7.57092 0.344645 9.78983 -282 2 10.1052 16.9888 12.7016 -6.07497 2.05659 -6.06408 -283 1 13.326 12.928 7.96212 4.69357 25.6567 2.07593 -284 2 13.3763 12.2768 8.65803 -4.91574 -13.7878 2.50151 -285 2 13.7353 13.7181 8.35204 8.56042 -2.58857 -8.38859 -286 1 14.9538 2.97298 15.3382 -4.29462 -11.8182 -2.96981 -287 2 14.4639 2.15222 15.1644 -2.78402 11.1896 3.17375 -288 2 15.6292 2.97829 14.6488 1.75 3.70602 0.0805282 -289 1 9.85487 15.5414 16.9955 1.72232 -1.82893 -0.169847 -290 2 10.3837 14.7676 16.7382 -3.42626 -0.271454 1.71497 -291 2 9.29261 15.2923 17.7497 4.44449 2.55726 -1.27949 -292 1 11.3089 8.30526 16.5494 -6.04997 -6.2326 7.21044 -293 2 10.5881 7.89563 16.0543 2.01853 1.78394 -3.12513 -294 2 11.4835 7.65722 17.2517 2.74023 7.81545 -1.84368 -295 1 3.836 18.1836 16.7517 -7.13385 -19.1452 -23.0441 -296 2 4.27407 17.4593 17.223 1.84106 9.67264 7.83483 -297 2 3.88222 0.348533 17.2402 4.94653 11.64 14.7969 -298 1 2.18178 4.13609 8.93005 8.1701 -0.774865 9.73019 -299 2 3.0913 3.90524 8.75773 5.46766 -1.37508 -11.1104 -300 2 2.14869 4.01328 9.88774 -11.2166 4.12208 2.959 -301 1 9.87742 10.3647 9.70242 2.63105 14.1486 10.9213 -302 2 9.56679 11.2208 9.35298 -0.359428 -9.80694 -0.658425 -303 2 10.1334 10.5423 10.6269 -4.00587 -8.10964 -6.10976 -304 1 9.70429 0.823826 10.8553 -14.0108 4.16215 1.0267 -305 2 9.1278 18.77 11.1938 11.0832 -7.32823 7.11532 -306 2 9.14207 1.22722 10.1856 4.51331 8.02138 -6.87563 -307 1 9.20617 15.1402 10.2178 -11.609 -5.72992 -0.101326 -308 2 8.7465 15.767 9.6415 2.03963 4.50002 1.17892 -309 2 8.51696 14.4821 10.4282 6.2553 7.07807 -5.66984 -310 1 0.996164 9.40777 10.3157 -31.4617 35.4735 1.80375 -311 2 1.02993 10.3821 10.3914 -11.0752 -10.4846 4.01107 -312 2 1.89609 9.22017 10.2201 37.6387 -20.6805 -6.1303 -313 1 16.8786 4.85128 8.17759 -11.2506 16.3288 -5.48708 -314 2 16.2388 5.56314 8.38188 8.44756 -9.04525 0.78656 -315 2 16.9626 4.34108 8.98054 4.36808 -7.38136 2.74573 -316 1 14.6815 14.711 0.319263 14.4838 0.937126 -3.06264 -317 2 15.2721 14.9301 1.06391 -7.87321 4.75235 -6.44468 -318 2 13.8763 14.3724 0.714255 -5.91657 -4.41648 2.02008 -319 1 3.57415 11.0448 9.58418 2.91679 3.40936 2.58946 -320 2 3.69173 11.5263 10.4228 -3.34733 -6.02301 -1.37626 -321 2 3.07399 11.6483 9.00652 3.80152 0.245021 0.575116 -322 1 11.1013 10.8086 1.33492 -13.1151 -1.75228 0.351043 -323 2 11.4484 11.639 0.990604 2.68761 3.85867 -0.677593 -324 2 10.1644 10.7789 1.04773 13.6271 -2.80152 6.25142 -325 1 13.1828 7.11823 12.837 13.875 6.93007 -2.08809 -326 2 14.1546 7.00576 12.8731 -8.73741 -0.33434 -1.11439 -327 2 12.8407 6.21951 12.8306 -5.12621 -6.60309 0.0889066 -328 1 9.62491 1.88499 0.973614 -3.42399 -6.06492 -12.2684 -329 2 8.82152 1.4846 0.597998 2.34171 8.22807 3.07369 -330 2 10.1781 2.12743 0.21359 -0.384483 0.556473 6.61436 -331 1 10.6031 13.5334 4.66686 13.636 -3.8461 -1.22567 -332 2 11.4763 13.1252 4.55872 -4.58351 -5.15517 0.0143246 -333 2 10.7077 13.9241 5.53959 -7.66657 9.10334 4.04553 -334 1 14.3485 1.75735 10.9256 -1.10429 -17.7549 1.09656 -335 2 15.1861 1.44338 10.54 -2.80824 6.90847 2.1648 -336 2 14.3834 2.71874 10.9625 8.08978 3.11888 -5.0019 -337 1 14.6333 12.3432 11.6996 -1.39952 -9.16637 -24.1357 -338 2 15.3681 12.4502 11.0746 9.0546 4.11007 14.4837 -339 2 13.9355 12.122 11.0753 -11.0061 -2.1546 9.49113 -340 1 8.24004 5.06512 9.81661 -6.73852 -15.0928 -6.1646 -341 2 7.43321 5.24609 10.2868 -7.68507 10.8263 10.6715 -342 2 8.07004 4.14881 9.53169 13.9201 5.19095 -3.88371 -343 1 1.57861 16.855 18.3455 -3.6047 -18.8696 23.6299 -344 2 1.81992 17.2862 17.5419 10.6717 7.49965 -18.3027 -345 2 1.88846 15.9289 18.2434 -7.51751 10.9825 -1.36554 -346 1 1.48469 17.2399 15.3369 -30.5992 8.85894 1.58219 -347 2 1.52903 18.0991 15.7763 5.64601 2.15314 -3.36931 -348 2 0.515015 17.0623 15.2815 21.6878 -4.25813 -0.913042 -349 1 3.6961 5.66103 6.13276 1.27154 -4.68408 -0.174538 -350 2 3.02861 6.15393 6.634 5.94065 6.05513 -0.564102 -351 2 4.2706 6.29315 5.66099 -8.13711 -1.6893 2.05746 -352 1 12.3863 9.46112 14.1898 5.64676 -22.9439 1.72589 -353 2 12.6155 8.61212 13.7476 3.53191 14.2422 4.21489 -354 2 12.2183 9.16782 15.1036 -0.67103 6.17556 -4.58111 -355 1 4.03262 15.2884 6.88962 -6.96122 -2.16466 3.53978 -356 2 3.61008 16.076 6.4989 3.67472 -5.21865 6.04109 -357 2 4.98914 15.3892 6.82497 3.29203 7.08348 -5.36605 -358 1 0.610585 8.57451 14.9167 2.06858 8.16468 9.66942 -359 2 0.571526 9.5334 15.101 -0.509723 -6.74541 -4.80249 -360 2 1.24768 8.49017 14.2004 3.24343 3.39805 -1.00154 -361 1 12.9947 8.30502 10.3347 -2.10898 5.96297 -3.02925 -362 2 13.7245 7.79451 9.98073 4.34503 -3.62623 -11.9067 -363 2 13.0194 8.04092 11.2546 -7.35013 -0.655157 9.61409 -364 1 15.3021 7.68636 3.53463 20.0464 32.042 -6.64886 -365 2 14.6007 7.2355 3.06802 -7.18972 -17.1123 8.01585 -366 2 15.7144 7.29713 4.32433 -16.1768 -11.7678 -0.766084 -367 1 17.3034 6.68003 0.0493874 -1.84179 -13.5509 -2.88881 -368 2 16.9519 5.78424 0.161568 0.711034 6.10552 3.25575 -369 2 16.5083 7.2036 18.5276 -0.473138 7.46776 -7.84911 -370 1 8.84315 6.93181 7.84628 -0.943806 11.0529 -13.3888 -371 2 9.77771 7.20927 7.80441 -6.03996 -2.82935 4.46193 -372 2 8.74315 6.27043 8.54219 4.24547 -3.80386 5.92931 -373 1 12.3578 0.616451 1.20223 7.02437 -6.39463 -1.478 -374 2 13.2861 0.535705 1.47006 -5.02329 6.70293 3.96338 -375 2 12.2631 18.6802 0.444477 -1.70715 1.25222 -1.43865 -376 1 5.64724 15.135 14.5406 -0.604856 -11.7009 0.79572 -377 2 4.70142 15.1669 14.7844 5.92695 5.15448 -4.69419 -378 2 5.94602 16.0188 14.2721 -2.36621 0.047849 -2.09121 -379 1 3.86203 6.47491 1.73695 1.36817 -0.22553 5.39386 -380 2 3.46749 7.3178 1.48065 -2.80916 3.79134 -8.60259 -381 2 4.09027 6.61791 2.66801 -1.52617 -4.74348 -3.78665 -382 1 3.89615 11.6258 12.3135 -4.96985 -7.23752 -2.42851 -383 2 4.76636 11.9561 12.5635 2.33504 5.86151 0.242199 -384 2 3.23901 12.1927 12.7515 8.69891 -3.88643 -0.482475 -385 1 5.40213 3.8611 15.8693 10.8945 -12.2769 2.09816 -386 2 6.15363 3.21949 15.8699 -18.4435 12.0745 -5.1575 -387 2 5.79254 4.73962 15.8533 3.23601 3.32406 0.742539 -388 1 14.4255 10.2871 4.42158 -5.00773 -17.9107 13.5675 -389 2 14.5181 9.70279 5.20492 2.69814 10.8256 -8.91808 -390 2 14.7837 9.77905 3.68069 -0.206993 2.85241 0.289205 -391 1 7.87167 17.3723 9.20121 -10.8695 6.25183 -3.73994 -392 2 7.03582 17.6433 9.5986 1.28641 -7.15132 6.24862 -393 2 7.9635 17.9776 8.45108 8.3983 -5.79413 -1.77097 -394 1 4.52981 14.473 3.9851 -7.27149 14.4717 16.1092 -395 2 4.4292 15.3844 4.34508 5.86047 -13.4028 -12.5476 -396 2 4.51094 13.8931 4.76638 0.622359 -0.721789 -7.97238 -397 1 14.2548 7.40188 15.768 -9.88191 3.80355 1.83721 -398 2 15.2055 7.32768 15.6782 10.3356 -1.93634 -2.70959 -399 2 14.1214 7.72007 16.6658 2.42251 2.42868 0.921806 -400 1 2.92318 18.2319 1.90056 8.21916 -2.84793 -3.01579 -401 2 2.38261 17.6158 1.3774 3.82694 3.92633 -2.29165 -402 2 2.32657 18.895 2.2462 -10.4983 4.84254 7.82145 -403 1 7.9872 1.59624 4.55123 -13.2342 7.82044 -5.09514 -404 2 7.38456 2.15817 4.04087 -4.12207 -9.74777 1.09289 -405 2 8.829 1.94177 4.28864 19.9647 -0.586446 1.64736 -406 1 2.52886 14.1331 17.7106 9.56011 -8.28606 7.0204 -407 2 2.01365 13.3855 18.0679 -1.20108 10.5585 -3.23507 -408 2 3.45026 13.9294 17.9721 -7.58546 -2.42865 -2.00823 -409 1 0.784808 1.71729 13.877 -22.3729 3.14932 11.7627 -410 2 0.820241 1.39718 14.7912 6.0833 4.21121 -6.47959 -411 2 18.4913 1.99435 13.7832 17.5446 -4.15928 -6.69512 -412 1 4.49906 18.6473 13.9354 -18.7945 1.8826 8.61585 -413 2 5.41644 18.4141 14.0419 11.9469 -5.27484 -6.26214 -414 2 4.07897 18.3597 14.7657 2.79866 5.45516 -5.58976 -415 1 7.09283 0.599142 18.3486 34.6471 -4.12786 -6.63011 -416 2 7.39021 0.234617 17.4878 -9.84259 3.28252 9.67216 -417 2 6.14438 0.553251 18.3894 -16.3447 5.16139 0.014819 -418 1 16.0881 18.4309 14.0453 5.06229 7.716 24.0321 -419 2 15.2482 18.0804 13.8032 -16.2536 -8.6858 -12.6141 -420 2 15.9952 18.587 15.0073 9.58514 -0.127307 -10.5143 -421 1 10.0776 4.50678 16.2676 12.8821 37.0646 3.31891 -422 2 10.9819 4.89306 16.3611 -10.6263 -20.5161 -3.34059 -423 2 10.1424 3.55939 16.3223 6.24363 -16.5382 -1.58612 -424 1 15.8992 17.8398 4.41934 12.2004 7.51097 -4.98004 -425 2 16.3832 18.6941 4.42415 -3.71288 -10.9395 3.02327 -426 2 14.9903 18.0494 4.62819 -9.96916 6.21932 6.5896 -427 1 6.98832 17.3871 13.7576 13.6855 5.49553 14.8404 -428 2 7.37965 17.5993 14.631 -4.71479 -0.449691 -14.3122 -429 2 7.76575 17.2997 13.1656 -13.1106 -1.1113 5.84114 -430 1 13.2824 6.5097 6.67953 4.56939 11.9611 -5.54075 -431 2 14.0532 7.04843 6.47095 5.72005 -2.26771 11.4806 -432 2 12.9258 6.37058 5.8058 -10.6331 -8.36185 -8.97535 -433 1 7.75109 2.3756 9.23631 -5.33505 -3.40336 15.3372 -434 2 7.18759 2.24157 10.0186 8.87424 2.78019 0.355864 -435 2 7.20141 2.0575 8.52046 -4.61968 -0.366971 -12.063 -436 1 15.1734 14.8403 13.6669 0.441467 -1.73197 5.96822 -437 2 15.0738 15.2212 14.5455 0.591215 -4.0348 4.14746 -438 2 14.518 15.2716 13.122 -1.09719 2.73458 -8.10719 -439 1 9.35119 8.31644 3.739 2.66762 7.66889 5.69365 -440 2 10.15 8.71947 4.13947 -5.98752 -7.29531 -6.80605 -441 2 9.38201 7.35632 3.87197 4.69073 2.10751 1.74529 -442 1 17.751 13.5231 16.4139 1.76506 1.52762 0.696064 -443 2 16.8205 13.2419 16.3833 1.32585 7.25436 -2.93419 -444 2 17.8025 14.3962 15.9827 -4.54797 -4.37418 0.927992 -445 1 4.99908 10.6417 2.69781 -10.2301 11.821 9.59097 -446 2 5.61637 10.2237 3.29708 11.0389 -6.03173 2.08237 -447 2 4.70065 11.4181 3.20566 0.509198 -9.80178 -10.0294 -448 1 3.73671 8.33589 10.2301 0.811909 12.56 -11.1256 -449 2 3.79833 9.26935 9.95307 1.30999 -3.93497 -1.66187 -450 2 3.73931 8.38186 11.1831 0.045476 -4.76093 8.99044 -451 1 16.0469 7.05349 6.21752 -8.36922 7.98368 -7.54927 -452 2 16.8656 7.47651 6.4961 3.44749 0.07849 4.67395 -453 2 16.1438 6.1088 6.32704 6.52122 -4.4821 -3.05144 -454 1 15.1289 7.04368 9.08785 10.4694 9.8467 1.75835 -455 2 15.8264 7.38614 9.67453 -3.18259 -3.19274 -6.50653 -456 2 15.1274 7.66298 8.34243 -1.48772 -3.73631 0.00250057 -457 1 6.37899 13.0555 12.8241 7.15095 -9.93714 4.62427 -458 2 7.14263 12.6042 13.2293 -5.49135 0.351509 -10.6671 -459 2 6.23455 13.8287 13.3737 -7.10156 7.81238 6.40695 -460 1 12.1361 4.49173 13.0886 -33.3605 -9.49617 -7.12831 -461 2 12.0495 4.6518 14.0281 12.9755 3.95225 11.8447 -462 2 11.274 4.06082 12.879 23.5373 6.19102 -2.9945 -463 1 11.3516 8.18262 7.87035 -14.4325 7.02786 -3.11936 -464 2 12.0471 7.65769 7.46008 8.6713 -7.43794 3.47117 -465 2 11.5359 8.26397 8.81258 10.0684 -2.50636 2.15934 -466 1 17.1915 10.8124 7.44959 -16.1176 10.6393 13.8832 -467 2 17.9047 10.1798 7.28217 -0.931293 1.13858 -10.0543 -468 2 16.9855 11.3827 6.68215 10.1883 -6.89581 1.62445 -469 1 5.25104 18.1119 11.0466 -2.03712 6.82198 -5.53245 -470 2 4.55844 17.9395 11.7023 5.22213 1.54215 -0.259713 -471 2 4.79647 18.4173 10.2467 -3.05137 -7.80568 1.06144 -472 1 7.59144 17.5428 1.82585 2.02366 6.3387 -27.4892 -473 2 7.8094 16.7742 1.27336 1.17923 0.135637 10.7354 -474 2 7.55288 18.254 1.15356 -7.65387 -5.36774 12.2151 -475 1 1.92063 12.9184 13.6023 -9.91855 -8.75107 -5.23832 -476 2 1.37345 12.2779 14.0844 5.59931 4.65398 4.03533 -477 2 2.08932 13.6638 14.189 3.88592 4.92281 2.07481 -478 1 9.68002 6.79239 14.8375 -5.9785 1.55821 1.53848 -479 2 9.8605 5.87105 15.0454 -1.79232 -6.14635 7.43903 -480 2 10.0701 6.92553 13.9753 -0.129146 4.69231 -11.1498 -481 1 15.2463 4.32976 10.758 3.34542 15.1712 12.775 -482 2 16.1952 4.27653 10.855 10.1577 -17.3864 -7.84826 -483 2 15.0718 4.96713 11.4544 -13.5892 3.80238 -1.28771 -484 1 11.2223 6.14234 0.184515 14.935 15.986 0.702496 -485 2 11.3427 5.2537 -0.179589 -9.34658 -3.11564 3.17557 -486 2 10.3073 6.45674 18.8196 -5.33379 -13.1911 -7.29958 -487 1 0.101128 11.3538 15.0994 -20.5112 19.1646 -16.3994 -488 2 18.0631 11.5965 14.4157 17.8209 -6.40715 11.0417 -489 2 18.7281 12.1498 15.6639 -2.69532 -11.5931 2.167 -490 1 7.07341 9.21118 7.26397 13.6545 -4.38359 1.14819 -491 2 6.46912 8.52168 7.54812 -6.91606 -6.22713 3.38737 -492 2 7.94495 8.78194 7.35853 -7.81842 8.24868 -3.32543 -493 1 18.379 15.4045 12.3485 -3.73833 -6.55761 4.14497 -494 2 0.693581 15.4288 12.2501 6.70794 3.85833 -5.56408 -495 2 17.998 15.8269 11.5664 0.97425 0.444703 -1.66759 -496 1 16.5516 4.36462 5.23826 -5.38189 5.67955 -17.8631 -497 2 16.655 4.28498 6.19256 13.2509 -4.37544 3.08954 -498 2 17.3965 4.59413 4.7818 -8.47419 -6.89051 15.5314 -499 1 17.7443 3.09877 10.7286 3.04827 -10.7181 -6.87848 -500 2 0.0283995 3.26624 10.9392 2.02267 5.05617 3.97045 -501 2 17.7464 2.2027 10.3321 -6.96828 10.7891 3.50943 -502 1 12.2779 0.0212452 10.1338 -0.475788 -3.12763 3.03365 -503 2 11.45 0.377358 10.5143 6.17492 -0.459139 -6.32122 -504 2 12.9469 0.721114 10.1609 -4.48032 5.31969 3.75096 -505 1 10.3747 9.79435 12.3975 0.995366 2.64477 2.84838 -506 2 11.0916 9.86004 13.0462 0.88472 -0.940912 -1.26785 -507 2 10.2331 8.84374 12.2815 -0.892889 0.226532 -0.81052 -508 1 0.549483 2.84316 7.02126 -1.47246 -21.9217 -16.5589 -509 2 0.577314 3.5439 7.66737 3.67317 4.63089 12.4819 -510 2 0.765862 2.00117 7.45653 1.04632 13.6877 4.9994 -511 1 0.405258 15.2829 6.93023 -2.49907 -5.43649 4.98244 -512 2 0.538371 14.8975 7.8327 2.16571 9.44122 -16.3162 -513 2 0.725684 14.6278 6.28848 -1.93707 -3.30699 10.9749 -514 1 17.0129 7.01771 15.2646 8.6122 -7.5627 -5.22629 -515 2 17.8138 7.53109 15.1273 -3.20292 15.4854 -2.58719 -516 2 17.4051 6.15342 15.4314 -10.2841 -6.73634 6.86556 -517 1 9.05466 12.4444 8.11302 13.0521 -10.4864 -20.5516 -518 2 9.3276 11.8473 7.39447 15.1337 1.48797 7.8591 -519 2 8.12011 12.397 7.99286 -24.7878 10.4099 9.23055 -520 1 1.26093 1.88381 3.01396 9.71768 11.5305 -0.318626 -521 2 0.781341 2.25664 2.27301 -4.68813 -2.91629 -4.97973 -522 2 1.78505 2.63319 3.35529 -3.04295 -14.2735 3.58948 -523 1 4.11799 15.1078 9.73252 4.576 2.76804 -1.92408 -524 2 4.09335 15.377 8.80945 -5.53143 0.588802 -2.3225 -525 2 5.02333 14.7824 9.83323 -1.70794 -2.53339 7.76874 -526 1 7.21252 2.18262 14.5895 -3.17269 -14.8219 8.52343 -527 2 7.02371 1.74902 13.748 4.05246 3.09826 3.19753 -528 2 7.71073 2.97164 14.4061 4.58862 11.2949 -7.92291 -529 1 18.5773 14.6793 2.1781 -14.8885 -13.9434 -3.10254 -530 2 0.806981 15.0773 2.13409 4.68638 9.16713 1.06255 -531 2 17.8879 15.3584 2.08187 6.00104 3.32119 3.09374 -532 1 9.95988 2.75708 12.9307 -3.19888 4.8993 -0.068744 -533 2 9.83509 2.14797 12.1955 3.80206 -8.82317 -3.94881 -534 2 9.20326 3.3528 12.8696 -1.08171 3.11286 5.06453 -535 1 2.85334 8.94069 13.0534 -9.07349 -10.7547 -1.24525 -536 2 3.30632 9.75091 12.8027 2.98523 12.1914 -0.768468 -537 2 3.53212 8.32042 13.3313 9.61222 -2.32206 4.81477 -538 1 3.22451 8.40753 3.67121 22.1548 25.1655 0.793749 -539 2 3.78763 9.07745 3.2153 -17.2399 -11.2925 0.757254 -540 2 3.40605 8.58793 4.60238 -4.67213 -6.04062 1.9181 -541 1 5.62069 7.18926 8.53747 6.69229 -2.05947 9.74796 -542 2 5.86853 6.28591 8.76536 -0.744086 -3.6627 -12.9201 -543 2 5.09246 7.43537 9.3012 -7.69944 9.66912 -1.05292 -544 1 14.8771 1.33506 1.99369 -4.37531 -14.3045 14.6387 -545 2 14.6174 2.14132 2.47402 3.99094 2.69357 -12.1219 -546 2 15.1274 1.48157 1.08098 3.94771 15.4277 -5.2716 -547 1 8.29964 15.2018 0.824762 -0.280237 2.12341 -18.5848 -548 2 9.0741 15.0554 1.38374 0.657448 -4.01578 8.69554 -549 2 7.56069 14.656 1.13255 5.04945 -5.16558 7.75703 -550 1 15.6052 1.34643 7.22407 3.75056 4.73875 0.699016 -551 2 15.0587 0.773182 6.67423 -5.35564 1.12746 0.995868 -552 2 15.1053 2.16848 7.37587 -1.8024 -6.33902 1.47434 -553 1 4.99443 13.0609 18.5093 -5.69789 -0.343563 -13.2097 -554 2 5.39232 13.2306 0.720212 5.08054 -1.92613 6.3414 -555 2 5.7137 13.1567 17.8693 -5.50653 4.49423 4.11534 -556 1 15.3782 8.49607 18.1492 -5.08872 -0.806473 3.30258 -557 2 15.7135 9.0139 17.4023 0.0404722 4.09908 2.1153 -558 2 15.1698 9.14329 0.203973 4.81283 -1.94937 -4.21801 -559 1 12.0917 3.05456 18.3485 5.25344 -19.9367 5.19329 -560 2 12.3328 2.56101 0.492796 -7.10973 11.5886 11.7441 -561 2 12.4167 2.41374 17.7115 -1.86526 8.77132 -18.5664 -562 1 13.1991 12.6728 5.17615 -0.124316 -0.0560055 4.18836 -563 2 13.6438 11.8331 5.03438 2.42254 -3.05364 -13.3032 -564 2 13.4089 12.8359 6.10375 -5.84435 4.2533 1.84347 -565 1 6.03469 7.1207 0.0631469 12.4635 -7.18562 -1.52206 -566 2 5.88549 8.01359 19.0305 -4.09863 7.65543 -4.79966 -567 2 5.21365 6.64029 0.190066 -5.29753 1.61074 5.21091 -568 1 17.6997 15.9613 14.987 30.7149 -12.4194 32.4504 -569 2 16.8862 16.4214 15.1458 -18.1669 6.52853 -13.961 -570 2 17.8877 15.7083 14.0822 -14.2113 6.66636 -19.3843 -571 1 13.1806 0.977208 16.5993 3.21446 -7.78263 -3.05852 -572 2 14.1069 0.725878 16.7441 -1.84519 3.55213 2.46319 -573 2 12.7536 0.148831 16.339 0.610986 0.436683 6.04854 -574 1 11.0624 14.5912 7.28204 -11.2181 -3.76258 -2.73638 -575 2 10.3867 13.9846 7.62705 2.11873 3.9908 3.08505 -576 2 11.9143 14.2091 7.50586 0.261112 -7.43153 0.664812 -577 1 17.506 8.58052 2.09005 -0.444247 -11.7988 -12.468 -578 2 16.6642 8.31502 2.4773 -2.50704 5.84538 6.9832 -579 2 17.563 7.99026 1.31874 6.86903 3.37396 8.78538 -580 1 12.3502 7.95652 1.98027 -3.36099 -5.49894 -2.13311 -581 2 11.9195 8.80992 1.98547 0.506131 9.65618 1.3531 -582 2 11.9377 7.50693 1.23044 6.6222 -7.49408 4.60604 -583 1 11.9327 14.6311 10.3511 -13.8226 21.3891 7.58711 -584 2 12.0851 13.8189 9.91206 10.3006 -23.5502 -10.4516 -585 2 11.0014 14.8158 10.1424 3.95037 3.15478 8.54077 -586 1 6.86541 7.01247 15.582 10.3214 -0.24422 -5.9518 -587 2 7.78025 7.06796 15.2658 -3.95377 -6.01896 -2.62563 -588 2 6.83046 7.729 16.2102 -7.67029 5.21932 8.6005 -589 1 8.00165 4.68416 13.4443 -21.8863 -22.7248 -23.0503 -590 2 7.36443 4.84116 12.7101 7.64348 -4.39085 15.7408 -591 2 8.44337 5.50298 13.5544 13.6077 24.8283 3.95349 -592 1 13.4082 12.1692 14.291 7.74384 0.583631 -6.74495 -593 2 13.3391 11.2097 14.1788 -8.03609 -0.555633 4.00216 -594 2 13.8852 12.4587 13.496 -2.17037 2.06617 1.19415 -595 1 14.784 9.43826 7.28323 -11.1269 12.8929 16.9671 -596 2 15.4951 10.0466 7.55684 1.33033 -10.8665 -8.82607 -597 2 14.017 9.71262 7.81429 7.01149 -4.68319 -9.50468 -598 1 12.6837 17.0142 3.10751 10.9269 -13.9095 9.51878 -599 2 12.9708 17.2813 3.99359 -6.48615 4.53386 -3.20168 -600 2 12.1282 17.7068 2.75827 -7.19321 10.5694 -1.73823 -601 1 1.13983 7.14905 17.429 -19.8537 -0.642492 -7.24746 -602 2 0.229092 6.89189 17.6928 9.24629 12.0374 -0.554306 -603 2 1.04788 7.63326 16.5858 1.73105 -6.23108 5.83737 -604 1 12.8283 5.10796 15.6891 -3.1105 -1.51238 -5.72518 -605 2 13.5351 4.46064 15.5231 -0.330328 2.49365 6.49287 -606 2 13.2544 5.98171 15.6287 1.13166 -7.6156 1.26811 -607 1 2.48175 3.38612 5.07416 -11.4746 -6.3359 16.597 -608 2 1.87059 3.13723 5.824 15.2627 10.0051 -19.3068 -609 2 3.07561 4.08306 5.41325 -9.83136 -1.83582 -2.79497 -610 1 8.32062 11.2204 13.4908 14.3326 -12.3724 2.23055 -611 2 8.41586 10.9603 14.3918 -15.5351 3.38632 26.9235 -612 2 9.1195 10.7822 13.1796 -2.73354 4.12568 -26.6086 -613 1 12.9112 1.40899 13.3219 3.38587 -22.7152 11.6955 -614 2 13.5257 1.21801 12.5994 -2.66679 10.6744 -3.40434 -615 2 12.4724 2.23119 13.1327 -1.22779 13.5514 -6.35015 -616 1 6.39925 13.6301 2.14388 13.7527 -0.778699 -6.56015 -617 2 5.84347 14.0897 2.78318 -1.88549 -3.79567 9.96763 -618 2 7.03431 13.0755 2.63977 -7.58465 4.89894 -0.0461429 -619 1 15.9327 6.56061 12.7538 -0.9836 2.19135 -10.6596 -620 2 16.5146 6.98287 12.103 -5.34808 0.40017 1.48081 -621 2 16.2873 6.8165 13.6112 3.99792 -3.90075 7.11277 -622 1 16.8306 0.705066 9.59578 -7.6122 -1.79623 -7.44488 -623 2 16.785 18.3903 9.75048 3.18156 2.06447 -0.865929 -624 2 16.3719 0.843651 8.74144 5.4764 0.262409 5.10626 -625 1 6.12658 11.6826 8.3633 -3.5227 -13.2845 -7.84739 -626 2 5.19255 11.5559 8.64231 15.2704 -3.4985 -2.63712 -627 2 6.45331 10.8168 8.01189 -8.18375 16.1965 9.35276 -628 1 2.85137 8.68091 0.385463 -5.58051 9.89965 12.0536 -629 2 2.19225 8.31695 18.4611 -2.16592 -25.8024 -20.6889 -630 2 2.2971 9.35613 0.77772 10.4924 10.4953 14.3564 -631 1 10.1291 10.4583 6.52809 -2.44089 1.08082 5.72444 -632 2 10.551 9.78353 7.0828 -0.111445 0.581803 -4.14441 -633 2 10.6952 10.5682 5.75546 0.540532 -2.90301 -3.90698 -634 1 6.75412 15.726 6.57209 -8.13971 -2.30487 -2.02419 -635 2 7.24364 15.9641 7.36655 2.15693 7.18823 -0.87292 -636 2 6.8879 16.4298 5.90744 8.86888 -7.67267 7.00242 -637 1 6.43944 13.0908 5.62507 5.5957 4.80241 6.78236 -638 2 6.68766 13.9873 5.91055 -1.86537 -6.12454 -2.89892 -639 2 6.02344 12.6885 6.39583 0.545895 -2.8305 -0.33431 -640 1 16.7919 12.5477 9.81186 8.33998 7.78307 -15.4118 -641 2 16.959 11.947 9.07064 -2.3739 -7.40637 3.16023 -642 2 17.0566 13.4004 9.43565 -5.48117 -2.43007 10.0621 -643 1 6.08508 2.94496 2.79534 5.32525 -4.78467 20.7365 -644 2 6.22401 3.88181 2.60268 1.06349 -0.160394 -8.38338 -645 2 5.80007 2.47136 2.00522 -4.08992 3.93243 -8.80646 -646 1 10.8869 3.24711 3.28239 -4.40001 1.54122 -3.81905 -647 2 10.3919 4.04182 3.50512 -0.182415 -1.04618 4.274 -648 2 10.507 2.97693 2.43998 1.37333 -6.80979 -0.861155 -ITEM: TIMESTEP -40 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.77679 7.00681 17.9176 19.5781 -11.4355 -6.13067 -2 2 7.88289 7.04978 18.2154 -24.3238 4.20085 7.9494 -3 2 8.82569 6.20257 17.3924 1.80136 1.41546 -3.93969 -4 1 18.6608 8.28849 6.81179 -5.26854 6.47195 -37.0065 -5 2 0.259818 8.10211 5.87223 -9.20216 6.37217 14.1473 -6 2 0.533966 7.65898 7.28863 11.4703 -14.4857 21.9358 -7 1 8.44459 18.6539 6.84319 -15.0888 3.44445 3.75329 -8 2 9.31627 0.207433 6.52222 15.1831 4.47029 -4.67038 -9 2 7.87035 0.688968 6.45696 3.7806 -3.44044 1.26969 -10 1 6.57294 1.78151 11.6706 -30.0599 9.45416 18.0529 -11 2 5.79693 2.24632 12.0928 24.7239 -13.8096 -10.3139 -12 2 6.23894 0.879353 11.5248 3.88204 4.12095 -2.29502 -13 1 7.0611 5.68864 2.39703 8.93877 -14.6422 -9.86735 -14 2 6.49127 6.20844 2.93802 -15.3109 10.2002 23.1803 -15 2 6.88849 6.05122 1.53455 1.63853 6.11013 -15.8751 -16 1 16.2018 10.2111 16.0976 42.0151 -2.30245 8.02011 -17 2 17.1767 10.3828 16.1846 -31.1897 -9.90141 -8.38467 -18 2 15.8087 11.0308 16.3852 -12.3763 9.98735 1.02793 -19 1 10.6387 14.9527 2.33657 9.03987 18.5511 -2.17595 -20 2 10.545 14.5243 3.1949 1.96881 -4.62445 -0.461144 -21 2 11.2262 15.72 2.53493 -10.4825 -13.512 -5.5858 -22 1 17.1607 8.25027 10.5569 -10.4361 3.90862 15.3578 -23 2 16.8456 8.92829 11.1924 -0.168965 -8.85021 -9.39988 -24 2 17.9277 8.63713 10.1294 7.74511 3.00226 -1.55375 -25 1 14.7566 15.8542 16.4215 -9.50848 16.8449 -9.38304 -26 2 13.8265 16.1715 16.4278 14.8795 -5.02546 -3.6071 -27 2 14.9162 15.569 17.3232 -2.48975 -11.4773 7.52297 -28 1 12.1331 13.4103 0.48985 -10.556 -4.43922 -13.5861 -29 2 11.9475 13.3795 18.1761 8.0664 -0.863413 7.07636 -30 2 11.3865 13.8946 0.862316 6.65844 3.98247 10.4433 -31 1 9.29843 5.44761 4.00486 3.37284 8.34248 -28.0116 -32 2 8.80378 5.24143 4.78809 -8.97197 -9.15203 12.3932 -33 2 8.61542 5.51114 3.30134 8.62356 -3.76178 8.99247 -34 1 1.79678 4.17189 11.6321 9.86643 -30.5991 16.8051 -35 2 1.62878 5.09135 11.8205 -3.04918 18.6361 6.49963 -36 2 2.25792 3.77365 12.4221 -11.5809 11.2089 -24.12 -37 1 2.02425 6.80455 8.32417 0.209126 8.78432 0.0974623 -38 2 2.41895 7.33028 9.04952 -2.4595 -11.9319 -6.9206 -39 2 1.91003 5.89259 8.64365 4.06316 7.1017 -1.03524 -40 1 5.41039 4.42866 7.97545 15.1976 -3.31539 14.1613 -41 2 5.46063 3.46886 7.81834 -3.32316 3.28084 -1.43066 -42 2 4.8072 4.83488 7.36206 -13.6118 -1.04066 -17.9483 -43 1 3.27942 2.94296 17.507 14.649 -12.38 -13.2068 -44 2 4.01307 3.22765 16.9192 -12.2988 4.29907 8.19647 -45 2 2.92414 3.72569 17.9407 -4.7152 6.06254 1.98711 -46 1 7.44402 5.32718 6.09908 -2.23439 -3.56175 -18.7368 -47 2 8.08992 5.98284 6.3762 -3.15187 6.11466 20.9447 -48 2 6.88688 5.06352 6.84221 3.51936 -1.39652 7.32666 -49 1 9.78623 6.99393 11.9838 -8.59529 -1.09594 -12.3674 -50 2 10.3445 6.45759 11.4052 1.55365 1.23763 7.43723 -51 2 9.00985 7.18223 11.4209 7.62587 2.79809 7.26056 -52 1 14.0725 3.61727 8.08367 12.8617 -8.18347 36.7285 -53 2 14.0228 4.31343 7.45005 -3.4794 19.1063 -13.5046 -54 2 14.4179 4.02628 8.91908 -9.29791 -10.4076 -21.8094 -55 1 4.59231 17.2384 3.97449 0.493238 3.33808 0.649061 -56 2 5.51414 17.4776 4.03994 12.0557 0.622386 5.90157 -57 2 4.23063 17.8039 3.28947 -7.41249 -4.06804 -9.31956 -58 1 16.4721 16.5989 10.1846 -15.657 14.3962 29.6607 -59 2 15.672 16.8273 10.736 23.5631 -12.0212 -18.4682 -60 2 16.1719 15.9965 9.50314 -9.75188 -3.46964 -7.56259 -61 1 1.98052 4.85246 0.373619 -1.44601 4.98585 -7.77412 -62 2 2.7262 5.17853 0.894803 -2.15831 4.7879 6.78517 -63 2 1.59165 5.65237 -0.0264377 4.8265 -6.05414 -1.09652 -64 1 11.6431 13.3034 16.3099 -7.83069 14.4437 11.7005 -65 2 11.0472 12.5464 16.386 4.77345 -10.1552 -4.34879 -66 2 12.2516 13.1635 15.5747 -3.53477 -7.02177 -5.05796 -67 1 10.1531 11.0326 16.9094 -23.9188 11.6521 -2.01913 -68 2 10.5087 10.1543 16.8125 9.70699 -14.9542 1.17008 -69 2 9.18648 10.9213 16.8155 11.1855 0.742098 0.22461 -70 1 11.7413 17.4552 13.4621 -1.23374 28.315 3.5075 -71 2 12.4767 17.2116 12.8888 0.8966 -9.51431 -5.30227 -72 2 11.7922 18.439 13.4864 2.17346 -17.034 -0.823798 -73 1 6.40572 9.32656 12.214 8.55802 19.8904 20.5686 -74 2 6.90308 8.91303 11.5283 8.82473 -10.1612 -21.9185 -75 2 7.05175 9.94906 12.6124 -18.2049 -7.77814 -0.199089 -76 1 16.2334 12.8098 2.68826 14.0272 -12.5996 -1.63763 -77 2 17.097 13.226 2.50419 -12.4159 2.28924 0.929092 -78 2 15.5495 13.4898 2.7216 0.770652 8.50493 2.13384 -79 1 0.665645 12.593 5.91595 32.2246 4.40393 3.59492 -80 2 0.90587 12.5095 4.99041 5.40697 -3.98614 -5.66175 -81 2 18.3758 12.6087 5.91046 -34.4951 5.63016 -3.48792 -82 1 5.23151 16.431 18.4431 -16.7943 8.81872 -4.95242 -83 2 5.79594 15.7593 18.0508 10.3373 -8.32481 3.89376 -84 2 5.47944 16.6222 0.707356 8.36178 -5.19521 1.40492 -85 1 0.571414 7.67431 4.12619 2.94709 1.59491 -2.60127 -86 2 18.6158 8.07004 3.46977 2.09916 -2.88444 -0.00351913 -87 2 1.46322 7.94524 3.84829 -2.55586 0.342718 0.201417 -88 1 3.11705 8.93424 6.4998 54.1901 -7.8337 2.25484 -89 2 3.7667 8.5317 7.12157 -13.167 10.549 -15.4875 -90 2 2.28764 8.76575 6.88741 -36.769 -1.96533 12.6863 -91 1 7.28047 10.3297 16.2671 12.2744 -1.5589 -10.8048 -92 2 6.65751 10.5384 15.5688 -5.93087 0.719661 3.96859 -93 2 6.78418 10.1979 17.0822 -4.65586 3.14184 2.44827 -94 1 11.1311 1.01006 5.00872 -4.59838 3.25637 13.1063 -95 2 11.104 1.87564 4.56859 3.00456 -5.57579 -4.19999 -96 2 10.7195 0.375584 4.41788 -1.87117 -0.379426 -13.1931 -97 1 4.37947 2.77237 13.219 1.2209 -0.528365 -1.66794 -98 2 4.72737 3.08878 14.0495 2.85744 14.0767 5.60955 -99 2 4.20383 1.85536 13.4394 -3.83295 -12.6961 -6.71285 -100 1 8.38383 10.1509 1.80871 -12.6182 20.2791 -9.41543 -101 2 8.178 10.838 2.47049 7.2019 -6.44506 -5.42193 -102 2 8.73482 9.42727 2.30684 9.9898 -17.6863 11.9989 -103 1 10.4319 1.72481 15.5562 12.4011 -4.85254 7.43664 -104 2 11.3895 1.56158 15.4091 -17.4954 3.73262 -0.131687 -105 2 10.062 2.13812 14.7716 6.37582 -0.463351 -11.2945 -106 1 2.70803 12.8564 7.7877 0.947466 12.6679 0.63847 -107 2 3.18684 13.6562 7.51328 0.350127 -6.04869 0.642024 -108 2 1.99719 12.778 7.13709 0.576803 -6.26493 0.417134 -109 1 3.70343 11.6943 5.19413 20.2082 20.004 0.0632986 -110 2 3.58824 10.8286 5.55511 -6.2763 -16.1433 9.0068 -111 2 3.08304 11.8089 4.48497 -14.3756 -1.22762 -7.56914 -112 1 6.79775 14.44 16.9261 12.4025 3.68508 -3.36544 -113 2 7.76361 14.3574 16.912 -9.58328 3.53086 0.838276 -114 2 6.54478 14.7426 16.0399 -3.94857 -4.38541 1.40645 -115 1 14.2011 14.5459 3.3522 -3.08566 -2.84615 -1.00806 -116 2 13.6596 15.3308 3.14384 3.83224 -9.07839 4.89455 -117 2 13.7292 13.9763 3.99269 1.14293 11.3016 -6.48612 -118 1 8.39096 18.1361 16.0337 -32.316 13.1552 1.22555 -119 2 8.83502 17.3455 16.3332 22.4875 -6.85104 -0.859562 -120 2 8.9267 0.219511 15.6905 18.196 -4.39201 7.01778 -121 1 4.72714 1.63535 4.92703 -26.6842 -20.3158 26.1173 -122 2 3.8064 1.92851 4.99525 4.72714 3.40068 -1.69015 -123 2 5.07003 2.08002 4.18139 17.9323 21.4409 -28.6349 -124 1 14.9964 12.7123 16.4352 -4.22015 -14.1687 -30.4934 -125 2 14.5029 13.21 17.0522 -6.30453 18.4993 32.9687 -126 2 14.3164 12.5754 15.7407 23.1427 -3.84454 1.0347 -127 1 15.7385 18.4508 16.8675 -13.9243 -22.2803 -23.7862 -128 2 16.4074 18.4637 17.529 20.9098 4.79862 21.1737 -129 2 15.5806 17.4953 16.7298 -7.09236 11.271 1.12369 -130 1 1.21817 1.19055 16.5653 11.7565 -7.97186 -17.2906 -131 2 1.96844 1.77109 16.7379 1.96571 4.11248 6.40071 -132 2 0.658106 1.26508 17.3256 -9.62795 7.29392 16.1709 -133 1 18.134 4.50826 15.9251 -3.15057 6.2034 16.9599 -134 2 18.3539 4.06683 15.1192 3.29697 -9.24478 -15.9855 -135 2 0.215105 4.3469 16.5346 0.451532 1.5183 -0.00159427 -136 1 12.2559 16.9635 16.13 9.81693 16.417 -30.969 -137 2 11.5335 16.7255 16.6761 -27.6315 -15.1383 17.2649 -138 2 11.8852 17.008 15.2138 11.4543 -2.176 15.2032 -139 1 16.0072 2.53826 18.0715 2.86853 -7.51147 -8.26075 -140 2 15.4847 3.23875 18.4474 -1.55266 16.6686 8.62869 -141 2 15.8031 2.59593 17.1292 0.710765 -2.58084 -2.04371 -142 1 6.70782 13.8427 10.2201 -0.679857 -3.70625 -19.7607 -143 2 6.50134 13.5235 11.1067 -0.321862 -5.5215 0.0793921 -144 2 6.59662 13.1168 9.5703 -2.40279 4.60459 14.5526 -145 1 10.136 18.3381 2.74267 -18.0567 -22.0341 20.6824 -146 2 10.1719 0.451126 2.17508 1.85432 15.9621 -15.8725 -147 2 9.21984 17.9907 2.65838 20.6262 7.0183 -5.07627 -148 1 3.02443 17.7208 6.1026 17.1013 10.0229 -4.66436 -149 2 2.15568 17.711 5.71196 -13.0363 -3.14036 -7.80794 -150 2 3.59824 17.9918 5.35649 -4.18715 -9.59785 14.6662 -151 1 12.576 16.8948 8.01086 19.6337 5.92584 -6.52436 -152 2 11.8143 16.3513 7.79321 -8.3204 -4.9503 8.18666 -153 2 12.4158 17.4227 8.81259 -8.93553 -1.00079 -7.85288 -154 1 14.8883 15.2954 8.22088 18.3997 -23.9506 8.44323 -155 2 14.185 15.9366 8.136 -10.7922 9.32905 -8.87486 -156 2 15.3949 15.2296 7.38647 -11.857 13.9652 6.76292 -157 1 17.682 18.2494 0.348905 -7.91474 13.422 2.87656 -158 2 18.5411 17.7865 0.321045 -1.05993 10.3639 -2.93184 -159 2 17.7527 0.554981 0.612143 9.7328 -21.6142 -4.56589 -160 1 0.864553 10.4271 1.36107 38.8853 37.5027 -14.379 -161 2 0.108953 9.99831 1.68821 -41.9718 -23.1906 9.82059 -162 2 0.582253 11.2112 0.83245 0.481516 -18.0373 9.72219 -163 1 1.69239 12.2275 3.35367 -4.8948 -13.153 3.57872 -164 2 1.37753 11.4769 2.79371 7.82838 19.3971 -0.83705 -165 2 1.72119 13.0511 2.84994 -1.71551 -5.72989 -9.02345 -166 1 0.593488 17.2339 4.88925 5.54216 -9.27995 13.1842 -167 2 18.6577 17.9974 4.73698 -0.720643 -6.26101 15.0882 -168 2 0.46443 16.7935 5.76992 -5.72363 16.5902 -22.8723 -169 1 1.11371 0.949119 9.43078 -14.7072 -12.8067 -15.4602 -170 2 1.29442 0.455313 10.245 -0.545661 8.99323 2.98013 -171 2 0.250893 0.599212 9.12975 16.3522 9.05079 5.79158 -172 1 16.7438 2.34594 13.2927 -5.57812 -16.9062 26.8121 -173 2 16.8801 2.6271 12.4058 4.66444 4.54161 -27.0891 -174 2 16.4868 1.39796 13.2842 6.06262 14.3342 0.102967 -175 1 2.62374 15.8311 12.1325 -18.0747 14.04 -25.4855 -176 2 3.15014 15.3809 12.7666 13.9506 -11.3972 18.0386 -177 2 3.07511 15.7224 11.2774 1.07994 -2.68321 4.96368 -178 1 16.4243 15.6576 6.03755 15.9104 -4.34147 -2.36376 -179 2 17.3476 15.7161 6.33483 -8.235 -6.85341 4.18965 -180 2 16.3427 16.413 5.44101 -7.92512 0.157724 -1.18513 -181 1 5.79129 5.09168 11.8004 -4.72983 -0.0241771 3.34223 -182 2 5.24592 5.67928 12.3598 8.87085 -1.40185 -4.45321 -183 2 5.33436 4.24005 11.794 -1.89173 5.24027 0.81451 -184 1 15.1611 4.86757 0.757741 -10.8083 7.02962 -6.60621 -185 2 15.185 4.56786 1.66832 -2.59424 -2.50065 9.27943 -186 2 14.3347 5.37902 0.687967 11.9305 -6.73266 -3.44958 -187 1 16.3215 16.3801 2.08305 3.66808 -22.0917 28.3334 -188 2 16.2883 16.7145 3.0131 -8.2177 -1.24054 -23.9705 -189 2 16.5228 17.1161 1.52724 6.03518 21.1991 -10.8898 -190 1 0.258418 4.84833 3.80491 9.83943 -33.1452 17.0376 -191 2 0.435143 5.7654 3.92096 2.60191 31.4745 -0.643169 -192 2 0.932226 4.39489 4.35318 -12.3014 6.6918 -13.6862 -193 1 2.96829 15.0617 15.1396 -6.44278 -4.84309 -5.22724 -194 2 2.79942 14.7982 16.0602 -0.108783 -2.99279 -5.19286 -195 2 2.41643 15.8476 15.0194 7.7594 2.37019 3.88633 -196 1 1.13965 14.6405 9.53256 -35.9747 -40.3241 22.6064 -197 2 2.06314 14.7027 9.49112 43.1319 12.9068 -8.07313 -198 2 1.0594 13.7772 10.0119 -9.44904 20.5678 -15.2205 -199 1 13.5675 16.5961 11.5382 5.93785 -23.7105 -2.52771 -200 2 13.3768 17.2545 10.8786 -7.41053 16.3631 -3.48345 -201 2 13.1856 15.7884 11.1314 1.00946 8.65797 10.7521 -202 1 4.66618 1.4643 0.77663 11.7421 5.19522 -12.5382 -203 2 4.19094 2.00712 0.127209 -4.75679 -3.07286 5.52347 -204 2 4.08138 0.751582 1.04859 -6.60629 -1.36494 5.43578 -205 1 1.44472 18.5589 11.8552 5.89014 -29.5111 2.70443 -206 2 1.28184 0.411827 12.6654 0.0657759 4.1157 4.72514 -207 2 1.66959 17.6355 12.1243 -0.811151 21.0135 -2.36357 -208 1 11.5239 10.1243 4.0099 -6.2394 6.26334 5.03821 -209 2 11.225 10.535 3.18075 6.07738 -4.97061 3.39644 -210 2 12.4891 10.1836 4.01184 1.61922 -2.52467 0.807021 -211 1 8.27885 12.1614 3.71144 8.13123 -6.41358 -26.5436 -212 2 9.10665 12.5897 3.97429 -2.42085 2.52867 6.94663 -213 2 7.68553 12.1691 4.45091 -10.6399 7.25218 24.1014 -214 1 14.4389 4.03262 3.28382 -1.54769 2.04788 0.687462 -215 2 14.9998 3.98927 4.07922 -0.140352 3.9435 -3.93632 -216 2 13.6855 4.60992 3.49399 3.24138 -5.01437 4.30138 -217 1 5.6049 1.66195 7.51556 2.43321 19.3851 -35.7094 -218 2 4.99817 1.05358 7.93111 -11.2062 -8.09843 6.71806 -219 2 5.29033 1.73413 6.56196 15.7086 -7.98236 30.9511 -220 1 17.8679 1.11465 4.8662 -8.84521 -11.3875 -0.414623 -221 2 18.5938 1.34898 4.28573 7.92092 9.45731 -1.66923 -222 2 17.9348 1.63294 5.67672 2.41874 4.31495 -1.38437 -223 1 6.82183 9.41821 4.49596 0.331068 -0.81956 4.69879 -224 2 6.92763 9.68813 5.42975 0.55668 -5.9518 -10.6641 -225 2 7.69076 9.13696 4.17138 2.49623 1.53594 7.84385 -226 1 2.6692 14.9191 1.96889 -13.7427 -15.0981 33.3863 -227 2 3.22272 14.7135 2.75628 -3.53882 5.4164 -17.9931 -228 2 3.23582 15.271 1.30455 16.0902 7.51076 -16.3339 -229 1 17.3236 12.914 13.1856 6.20451 10.459 -3.7314 -230 2 16.5162 13.3803 13.3896 -16.2035 -4.78456 4.03007 -231 2 17.8657 13.6659 12.9192 5.22743 -7.26423 -1.93052 -232 1 14.957 10.5619 1.40158 33.4378 15.8576 14.4167 -233 2 15.5687 11.2535 1.77718 -16.3935 -17.8486 -10.6273 -234 2 14.0947 10.9454 1.47451 -15.7071 3.57407 -1.68856 -235 1 5.70225 6.80052 4.56184 6.57688 14.9147 -7.26545 -236 2 6.13296 7.68472 4.64206 -12.0226 -12.483 -2.28626 -237 2 6.28869 6.17268 5.00191 2.5554 2.13057 5.94298 -238 1 8.01258 8.29623 10.2593 -8.54796 -9.21297 9.02749 -239 2 8.56841 9.06789 10.0886 3.62647 -1.62136 -15.6888 -240 2 7.62542 7.94814 9.4343 7.03713 6.69092 4.95874 -241 1 13.441 18.4149 5.75957 4.19405 2.302 -13.2138 -242 2 12.6243 0.255994 5.52243 8.89948 -2.22339 5.88848 -243 2 13.1991 17.7887 6.44621 -5.69407 0.108635 9.70575 -244 1 0.157493 2.61527 0.174457 -9.01339 -22.8294 -0.321401 -245 2 17.938 2.88173 18.4446 6.58659 5.28303 7.29983 -246 2 0.732894 3.35773 0.380844 -2.17088 12.8237 -3.11298 -247 1 12.7457 11.0391 9.7485 36.4778 -29.6492 25.4167 -248 2 11.881 10.9734 9.40839 -39.1103 -1.43989 -11.0388 -249 2 12.9187 10.1217 10.0968 -0.290925 20.2268 -9.99681 -250 1 0.740308 12.1745 11.0603 -22.9837 8.27774 -1.01284 -251 2 18.4139 12.2368 11.1424 7.83285 -3.43363 -6.48653 -252 2 1.04445 12.5328 11.8929 13.1768 -0.7817 9.81141 -253 1 5.09631 7.29496 13.4329 -5.02176 -6.40528 2.12919 -254 2 5.65923 7.87015 12.9013 0.281799 7.42737 5.37855 -255 2 5.54275 7.21467 14.2893 3.22018 -2.41867 -5.38403 -256 1 1.21307 6.88521 11.8471 45.2055 23.2855 19.4361 -257 2 0.504281 7.33909 11.418 -17.6401 7.5893 -9.966 -258 2 1.85566 7.62216 12.1147 -28.9146 -29.9066 -6.84092 -259 1 15.4951 9.58282 12.318 3.7565 -9.08444 -2.54037 -260 2 14.9885 10.3731 12.1762 -1.60608 19.4691 -5.65324 -261 2 15.197 9.26603 13.1641 1.66558 -4.92983 10.8479 -262 1 16.5876 12.7654 5.4778 8.29992 -4.99789 29.9812 -263 2 16.3841 13.7077 5.58453 -1.61151 1.51391 -8.42869 -264 2 16.4534 12.5134 4.57091 -6.79319 5.2662 -20.9737 -265 1 6.24519 9.93185 0.0511849 19.8307 -8.34124 26.5163 -266 2 5.62326 10.391 0.623031 -8.96333 4.37615 -1.09153 -267 2 7.04636 9.86115 0.632167 -14.2701 4.68407 -14.2447 -268 1 12.3094 6.10151 4.07154 29.4526 9.60181 -18.9544 -269 2 12.3581 6.67925 3.27122 -7.72489 -2.14158 19.4346 -270 2 11.4533 5.70734 4.07903 -24.5921 -5.49884 -2.8127 -271 1 0.238725 12.7856 0.183979 8.51406 3.08383 0.253195 -272 2 0.144933 13.4932 0.833619 -6.86037 1.22763 2.8825 -273 2 18.4214 13.096 18.0418 -3.66036 2.31192 -5.9902 -274 1 3.70956 18.598 8.57987 -8.91795 8.796 11.4474 -275 2 3.55449 18.0356 7.80833 -3.96611 6.10323 -0.149317 -276 2 2.8446 0.378518 8.78385 11.2365 -8.2841 -4.38951 -277 1 7.48876 17.3305 4.49636 -9.17434 -25.7083 -0.449464 -278 2 7.67261 18.2518 4.49855 7.01126 32.4538 5.60223 -279 2 7.56532 17.0943 3.57389 -1.71949 -1.63571 -7.00131 -280 1 9.24209 17.1007 12.2607 -0.0867103 -4.31389 -13.5747 -281 2 9.30622 16.4126 11.5797 -4.40084 -0.983353 3.37399 -282 2 10.1228 17.1279 12.6444 4.44927 1.46684 7.86514 -283 1 13.3362 12.9421 7.98122 6.55916 41.1429 -16.6734 -284 2 13.3796 12.1892 8.55526 4.57885 -11.5398 14.8452 -285 2 13.9495 13.647 8.31623 -8.21726 -16.9651 -6.13203 -286 1 14.9343 2.98184 15.3399 -18.8859 -3.08059 15.3623 -287 2 14.3306 2.22694 15.2091 8.05839 6.56319 -1.64083 -288 2 15.5611 2.99492 14.6188 6.00199 -3.60128 -9.94013 -289 1 9.8611 15.5568 16.9864 -5.18568 1.15062 7.50023 -290 2 10.3014 14.7282 16.7357 2.8278 3.85059 0.776615 -291 2 9.42894 15.4199 17.8518 3.24739 -0.30663 -9.25648 -292 1 11.3089 8.34774 16.5637 -8.99518 -4.25182 3.40254 -293 2 10.6351 7.93491 15.9913 5.93093 -1.15278 9.90769 -294 2 11.3777 7.78039 17.3602 -0.876032 6.75541 -11.8921 -295 1 3.86263 18.1743 16.7605 8.31608 -24.0238 3.67333 -296 2 4.34809 17.526 17.3016 -5.03788 -1.4921 -11.4176 -297 2 3.91859 0.291346 17.3034 -3.84782 28.4328 8.21839 -298 1 2.18675 4.1526 8.92206 -24.1698 7.19476 -17.4672 -299 2 3.08777 4.02084 8.66345 19.2563 -3.88604 2.84364 -300 2 2.11989 4.14607 9.87269 6.11123 -7.11558 17.6044 -301 1 9.878 10.3743 9.69372 5.53967 -18.4491 14.0185 -302 2 9.43572 11.1423 9.3425 -1.35277 14.796 -0.820696 -303 2 10.0526 10.4842 10.6451 0.294207 2.81912 -6.3598 -304 1 9.67606 0.861397 10.8616 12.1631 -0.119776 7.34561 -305 2 9.24662 0.0503119 11.2005 -2.60905 7.79605 -9.27605 -306 2 9.17358 1.27941 10.1433 -7.66403 -7.87567 2.43043 -307 1 9.19351 15.1133 10.2188 11.11 2.94282 0.236533 -308 2 8.72034 15.7288 9.64731 -2.95318 7.0206 -0.021652 -309 2 8.61234 14.3559 10.3013 -9.273 -0.749783 0.810803 -310 1 0.983709 9.49699 10.2982 -74.1988 19.4185 4.2569 -311 2 0.893433 10.4494 10.5162 13.7438 -13.7231 -2.84852 -312 2 1.86549 9.26486 10.2468 58.3196 -6.52918 -3.90093 -313 1 16.9084 4.83943 8.1598 4.06942 21.6595 -28.8412 -314 2 16.3724 5.61591 8.36865 -1.41178 -4.09344 3.51719 -315 2 16.8393 4.26054 8.89216 -0.699807 -17.3102 23.1105 -316 1 14.7125 14.7098 0.257213 21.3866 7.73012 -2.74727 -317 2 15.2455 15.0698 0.987096 -5.24332 1.02996 -2.3964 -318 2 13.934 14.3364 0.654485 -15.8904 -6.61515 6.72623 -319 1 3.61962 11.0361 9.55343 7.54802 -1.42323 12.4812 -320 2 3.62776 11.3571 10.4773 -0.544226 1.54555 -6.56144 -321 2 3.18313 11.7186 9.01674 -3.18494 -0.813089 -1.4949 -322 1 11.1481 10.7794 1.3867 -18.0125 -13.9714 2.13506 -323 2 11.5419 11.6189 1.17487 5.50703 16.2749 -10.1623 -324 2 10.2377 10.7815 1.02242 13.9743 0.382042 6.15217 -325 1 13.1644 7.14571 12.7934 28.1674 11.2254 -0.0108115 -326 2 14.1505 7.05998 12.7803 -16.3048 -3.53009 2.57838 -327 2 12.835 6.25234 12.9024 -6.40061 -9.363 -1.95696 -328 1 9.62034 1.87073 0.979069 -6.9897 -0.645983 -14.1021 -329 2 8.86926 1.41829 0.528843 9.90899 13.9476 5.87182 -330 2 10.1257 2.37739 0.312436 -3.40486 -11.198 4.68953 -331 1 10.6367 13.5403 4.62088 -14.2461 -11.7796 -9.34504 -332 2 11.3649 12.9086 4.64313 9.4379 4.41524 3.81629 -333 2 10.614 13.9519 5.48444 4.98914 7.07 10.6976 -334 1 14.3951 1.77229 10.9373 11.882 -13.8992 0.14286 -335 2 15.2529 1.46692 10.5904 -8.80209 -5.09491 0.192719 -336 2 14.4998 2.72321 10.9422 -3.89457 8.74507 -1.42899 -337 1 14.6035 12.2778 11.6732 8.28457 -2.47972 34.5189 -338 2 15.3822 12.4706 11.1386 -1.8445 -1.29245 -12.2333 -339 2 13.8238 12.1274 11.1597 -9.6117 -2.29221 -24.4043 -340 1 8.21682 5.05944 9.82725 33.2235 -12.7421 -22.1109 -341 2 7.50249 5.31613 10.3805 -26.8995 -2.6371 14.604 -342 2 8.16278 4.09579 9.61432 -6.39419 19.305 4.57693 -343 1 1.57178 16.8746 18.3696 -12.5949 -28.7752 19.8992 -344 2 1.95856 17.2997 17.6256 12.4489 12.7929 -23.944 -345 2 1.61191 15.9133 18.1414 3.74732 18.7705 7.54273 -346 1 1.50483 17.2622 15.3369 -31.2805 -0.211241 0.372367 -347 2 1.56428 18.1715 15.7008 -8.02099 -13.4799 -3.86937 -348 2 0.550545 16.944 15.3287 29.8388 16.9503 2.40621 -349 1 3.67189 5.70682 6.10259 2.52977 5.35962 -6.45813 -350 2 3.10512 6.24939 6.65687 -5.8484 1.84291 7.09291 -351 2 4.11645 6.33532 5.504 1.86189 -8.61654 4.18176 -352 1 12.4205 9.46682 14.1922 0.00765934 6.29699 5.01976 -353 2 12.7713 8.66673 13.7826 1.27338 -5.49384 -0.333278 -354 2 12.2037 9.20626 15.0998 2.51081 -2.42178 -0.168732 -355 1 4.04257 15.2822 6.8914 -27.6779 4.92775 8.06061 -356 2 3.56316 16.0906 6.63798 2.42102 -8.57509 -1.16647 -357 2 4.95231 15.5118 6.77617 25.3206 1.78005 -4.31003 -358 1 0.630616 8.59357 14.9621 0.0534875 13.3347 6.63524 -359 2 0.475879 9.54739 15.0951 0.802494 -5.58418 -0.636111 -360 2 1.32488 8.5708 14.2996 4.58301 -1.27906 -6.75903 -361 1 12.9988 8.28033 10.3217 -21.3611 19.4324 1.5895 -362 2 13.6573 7.74741 9.88515 12.8548 -10.016 -2.83384 -363 2 12.9714 7.9897 11.246 0.968107 -4.04745 -5.09921 -364 1 15.3184 7.7322 3.54707 4.18654 -9.90345 10.9868 -365 2 14.6375 7.17364 3.22195 -21.9236 0.488691 -25.4272 -366 2 15.542 7.2045 4.31452 16.9904 15.0521 14.7627 -367 1 17.298 6.68564 0.0426033 13.9193 -14.0885 -0.920406 -368 2 16.8642 5.82471 0.139777 0.0396094 5.05794 2.76644 -369 2 16.6003 7.28204 18.4358 -17.9105 11.3609 -4.38582 -370 1 8.85442 6.93876 7.83202 25.5204 20.9839 -12.9835 -371 2 9.78415 7.28149 7.87459 -21.3181 -5.86923 -3.23496 -372 2 8.81067 6.25344 8.49096 -5.61401 -13.4392 14.4413 -373 1 12.3763 0.596552 1.22002 -1.17453 2.99561 6.82033 -374 2 13.3385 0.528874 1.30915 -5.26207 -0.953155 0.827968 -375 2 12.0852 0.273415 0.369127 5.54968 -2.26078 -4.64309 -376 1 5.63283 15.1348 14.5573 -11.4131 -7.08845 -3.56826 -377 2 4.66833 15.2302 14.6984 9.61439 -4.03287 3.27369 -378 2 5.92452 15.9751 14.1944 7.77409 8.39082 -1.96781 -379 1 3.86657 6.44559 1.75085 5.80409 -14.6499 1.98717 -380 2 3.55249 7.31671 1.4889 -5.45171 9.45984 0.647045 -381 2 4.14269 6.4981 2.68117 -5.39897 6.08822 -6.8935 -382 1 3.91507 11.6157 12.3486 -13.4135 -1.42429 5.74998 -383 2 4.7693 12.0145 12.538 6.44699 -0.479912 -1.2837 -384 2 3.27735 12.1325 12.8813 7.77399 -7.15276 -11.5357 -385 1 5.36262 3.86651 15.8768 12.1389 -59.3419 -3.52329 -386 2 6.1064 3.19888 15.7551 -26.8485 22.8054 1.66706 -387 2 5.75212 4.71249 15.8089 15.627 34.646 -1.2618 -388 1 14.3819 10.2457 4.44716 -17.5064 5.46907 41.0935 -389 2 14.5449 9.71992 5.26671 -1.94493 10.8322 -14.5796 -390 2 14.8723 9.82528 3.76702 14.2142 -16.5996 -23.0963 -391 1 7.82031 17.402 9.18196 15.4978 -20.6961 5.52716 -392 2 6.95708 17.6159 9.5372 -6.73409 6.75657 -1.79958 -393 2 8.0438 17.9374 8.41052 -8.48575 5.6988 -1.01071 -394 1 4.52697 14.5011 3.99561 -1.64824 1.80571 -15.4173 -395 2 4.43911 15.4257 4.28139 2.0309 -4.99506 3.13673 -396 2 4.3827 13.9072 4.73582 -0.0495062 -0.930109 11.2178 -397 1 14.2192 7.41869 15.785 -17.5888 -3.59777 -10.979 -398 2 15.1626 7.35697 15.6947 20.631 -1.7403 -3.62609 -399 2 14.073 7.80524 16.6426 0.667235 5.42077 11.7037 -400 1 2.9565 18.2605 1.91108 1.19197 -18.909 -26.3864 -401 2 2.43337 17.7432 1.2423 11.354 8.34367 16.4878 -402 2 2.37308 0.276014 2.2689 -15.3488 13.3111 9.03739 -403 1 8.00359 1.60253 4.55907 -38.5212 -7.91491 7.83452 -404 2 7.38229 2.10405 3.99193 12.1921 -3.74558 1.60605 -405 2 8.88232 1.74243 4.26439 24.0023 10.0694 -13.3902 -406 1 2.4736 14.1336 17.6839 19.5549 7.85258 6.07398 -407 2 1.90347 13.5339 18.1719 -6.00167 -6.95039 -0.586477 -408 2 3.38553 13.9045 17.9683 -9.72011 -2.72883 -0.373401 -409 1 0.820064 1.73894 13.8888 -18.5285 5.33114 2.4032 -410 2 0.803771 1.49328 14.8397 -2.66487 6.43341 -16.8821 -411 2 18.5531 2.02517 13.6233 21.0072 -9.49287 13.5993 -412 1 4.44957 0.0409644 13.9204 -25.6038 8.03756 8.31677 -413 2 5.34611 18.3721 13.8825 17.1601 -8.5878 1.82821 -414 2 4.09536 18.4705 14.8092 8.9848 -0.155186 -10.4675 -415 1 7.11939 0.665063 18.3496 37.4596 -16.3367 -22.9959 -416 2 7.39046 0.248229 17.4868 -7.59422 10.3961 22.0522 -417 2 6.17976 0.73857 18.3349 -24.6121 7.91301 3.99406 -418 1 16.0679 18.4255 14.0033 46.948 4.07246 14.5496 -419 2 15.1925 18.2569 13.7481 -41.7006 -8.82757 -2.39817 -420 2 16.1514 18.46 14.9783 -11.5795 5.15321 -10.1321 -421 1 10.0899 4.51466 16.2755 46.1692 31.6348 -9.79269 -422 2 11.0262 4.80528 16.0633 -26.3332 -3.27592 13.4521 -423 2 10.217 3.58436 16.3451 -11.2214 -29.3564 0.661634 -424 1 15.916 17.7977 4.41903 32.6965 1.49817 -6.30174 -425 2 16.457 -0.0326327 4.45612 -4.70593 -7.03645 1.74937 -426 2 15.0663 18.0576 4.73092 -30.5769 8.16516 8.13282 -427 1 7.01211 17.4116 13.808 -11.1093 -0.0306798 -7.53718 -428 2 7.48321 17.731 14.5797 1.71822 -1.35338 6.01299 -429 2 7.70771 17.2257 13.1599 -0.832239 2.47859 1.40448 -430 1 13.2731 6.49483 6.63036 5.49864 12.0855 21.8831 -431 2 14.0036 7.1367 6.53142 -6.95912 -13.4785 -6.50558 -432 2 12.9191 6.26998 5.7719 1.78547 5.07661 -13.1828 -433 1 7.78873 2.35817 9.26787 13.6578 7.92928 32.9359 -434 2 7.26595 2.28464 10.098 4.41261 -4.66671 -14.4408 -435 2 7.24114 2.08424 8.54668 -18.4281 -7.28868 -15.4379 -436 1 15.1807 14.8213 13.6836 12.0158 -14.5979 1.51453 -437 2 15.023 15.1631 14.5679 -5.44227 3.64048 5.06686 -438 2 14.7818 15.3898 13.0312 -8.03448 9.52233 -3.65179 -439 1 9.37687 8.31604 3.76928 5.34304 4.19186 5.02399 -440 2 10.2244 8.59911 4.15846 -6.46746 6.21109 -7.45595 -441 2 9.38739 7.36131 3.86692 -0.369722 -6.10407 -0.56198 -442 1 17.7826 13.5587 16.3931 -18.259 -13.3606 7.93732 -443 2 16.8564 13.2543 16.3515 3.23179 3.05811 2.18424 -444 2 17.7493 14.412 15.956 6.45918 8.6709 -4.68033 -445 1 4.96945 10.6182 2.7671 -20.0352 21.3698 -14.9929 -446 2 5.67156 10.2863 3.30832 14.7689 -7.42384 15.9186 -447 2 4.73305 11.5 3.12196 4.54065 -18.1741 -2.81522 -448 1 3.75186 8.34553 10.1595 -2.54049 11.5371 -18.7835 -449 2 3.83158 9.28658 9.87851 -1.62744 -10.9109 6.60301 -450 2 3.69687 8.33176 11.111 2.12623 4.07512 13.0596 -451 1 16.0105 7.02075 6.14683 -8.93467 17.9282 -2.69417 -452 2 16.8191 7.42843 6.45697 9.04966 6.41713 2.22097 -453 2 16.1641 6.09023 6.1704 3.21598 -21.4167 -2.94797 -454 1 15.1148 7.07457 9.06702 4.51295 -11.3361 21.5265 -455 2 15.7278 7.43111 9.72685 3.64545 -0.886375 -6.04752 -456 2 15.1684 7.6713 8.33808 0.281889 14.352 -20.2518 -457 1 6.32562 13.0044 12.7823 3.64263 -12.4915 -10.2251 -458 2 7.18031 12.5985 13.0233 -9.44077 2.88231 5.28619 -459 2 6.10277 13.6925 13.4113 4.07235 10.5841 12.4872 -460 1 12.13 4.50388 13.0978 -23.9143 -18.2098 -29.5576 -461 2 12.2018 4.66005 14.0386 -4.52664 -3.61945 12.4396 -462 2 11.31 3.95423 12.8708 29.5104 21.9629 17.7949 -463 1 11.3628 8.1671 7.89263 -5.63688 4.26156 -3.21905 -464 2 12.0486 7.63378 7.48497 5.26632 -9.68169 -9.18733 -465 2 11.6596 8.25059 8.79652 3.08614 3.11673 13.4283 -466 1 17.1728 10.8467 7.48683 -9.78257 9.61375 -3.53187 -467 2 17.8082 10.1926 7.21604 13.2987 -16.4259 3.23364 -468 2 17.1151 11.4269 6.71399 -11.2446 1.98681 4.69156 -469 1 5.26156 18.1118 11.0164 11.279 0.780011 3.76881 -470 2 4.63029 17.9037 11.706 -3.79608 -1.61163 6.00067 -471 2 4.75114 18.4846 10.3039 -10.5863 -2.03901 -14.6626 -472 1 7.60927 17.5116 1.80376 -12.2084 0.332405 -16.0787 -473 2 7.73547 16.6894 1.27511 4.49641 20.7738 7.60921 -474 2 7.29137 18.2078 1.17993 10.7818 -15.1152 7.96202 -475 1 1.93242 12.9038 13.5907 -11.1009 -8.62515 -2.91716 -476 2 1.44204 12.3193 14.1878 -0.742257 0.132846 -0.79095 -477 2 2.14259 13.6778 14.1103 6.96653 11.7909 8.84583 -478 1 9.6349 6.79099 14.8483 -7.90933 -4.5792 7.57822 -479 2 9.76837 5.84646 15.0736 0.917781 12.494 -4.6794 -480 2 9.97866 6.97841 13.9703 0.736717 -7.57275 -8.26148 -481 1 15.2733 4.3257 10.7584 -18.0594 -0.89979 -6.45033 -482 2 16.1458 3.96681 10.9687 3.533 12.3702 4.36819 -483 2 14.9475 4.94569 11.4317 15.7147 -3.56113 0.605423 -484 1 11.2438 6.16931 0.179082 0.0277951 -2.16566 -3.90965 -485 2 11.3357 5.30361 18.4317 14.8036 -12.0621 -1.88578 -486 2 10.2956 6.2638 0.1816 -11.5861 14.503 2.02073 -487 1 0.0439986 11.3816 15.0585 -6.49496 4.09431 2.20477 -488 2 18.034 11.5578 14.353 7.75523 3.54925 4.26198 -489 2 -0.111373 12.1024 15.7029 3.25408 -7.01329 -10.5532 -490 1 7.06114 9.23722 7.26386 23.5376 12.3273 -0.106793 -491 2 6.50127 8.56776 7.63843 -10.2441 -19.5548 5.03643 -492 2 7.97426 8.90952 7.38371 -13.166 2.65106 -3.29749 -493 1 18.3483 15.3728 12.3401 -6.10947 1.64082 -0.490965 -494 2 0.640544 15.4003 12.1341 13.3619 2.30286 0.418231 -495 2 17.9315 15.8707 11.6253 -4.70162 -1.66258 -3.35097 -496 1 16.5284 4.37134 5.23872 23.865 15.8443 -24.0922 -497 2 16.795 4.23475 6.13242 -1.17196 -10.8972 27.7735 -498 2 17.3848 4.63349 4.80865 -25.3878 -11.1359 -1.24016 -499 1 17.7266 3.13043 10.7284 -15.1505 -16.4799 -4.03799 -500 2 -0.0205156 3.31599 11.0266 10.8372 -1.61224 -0.261482 -501 2 17.686 2.21262 10.3629 5.98361 15.5222 5.29053 -502 1 12.2768 0.00077952 10.1229 -5.39949 -11.0736 -0.564535 -503 2 11.3994 0.337416 10.3512 -3.44242 -0.519791 1.58275 -504 2 12.8621 0.740723 10.2534 12.1364 13.942 1.61795 -505 1 10.3933 9.78571 12.4371 -17.696 -6.66554 -9.33286 -506 2 11.04 9.8019 13.1479 9.02187 0.111511 2.28178 -507 2 10.1583 8.84624 12.3274 6.95171 5.58218 -0.582165 -508 1 0.583846 2.83323 7.01904 8.81732 -31.8654 7.83245 -509 2 0.599611 3.49885 7.68934 -3.58556 22.6003 9.07619 -510 2 0.952398 2.07883 7.51841 -6.10214 6.37924 -11.0018 -511 1 0.367433 15.2949 6.92522 -4.7012 3.61818 34.4112 -512 2 0.558547 14.7156 7.70153 -1.71176 22.246 -5.06421 -513 2 0.60814 14.7658 6.19753 10.4713 -26.0103 -27.8181 -514 1 17.0409 7.00624 15.2099 -22.5014 1.92016 -1.24665 -515 2 17.7387 7.65639 15.0691 10.2085 -5.07189 3.59706 -516 2 17.3996 6.21947 15.6455 8.09739 1.82665 -3.45815 -517 1 9.08645 12.4582 8.07298 60.2845 4.68897 0.226728 -518 2 9.45122 11.8173 7.41895 -17.2892 5.38378 7.41181 -519 2 8.16079 12.445 8.11596 -46.4448 -7.25102 -10.4423 -520 1 1.26434 1.84534 2.97351 6.14985 -4.32801 10.6126 -521 2 0.602074 2.03133 2.30849 -1.31532 11.5451 -8.74279 -522 2 1.61884 2.681 3.33622 -3.80121 -10.2767 -5.51985 -523 1 4.10472 15.1163 9.79145 -1.9934 -0.675971 8.59173 -524 2 4.064 15.4281 8.88095 5.53492 -3.39313 -4.80569 -525 2 4.98866 14.7298 9.93327 -5.1567 4.83883 -4.62826 -526 1 7.25259 2.18349 14.6213 0.0617677 -13.2081 -4.74626 -527 2 7.15489 1.70536 13.7831 -3.1697 0.657011 7.79217 -528 2 7.60954 3.02479 14.3607 5.63067 15.2107 -2.58221 -529 1 18.5424 14.6505 2.1789 -18.2195 12.8357 -3.23587 -530 2 0.746704 15.0923 2.14855 14.3998 1.01071 2.70778 -531 2 17.888 15.3836 2.15154 2.4051 -14.4939 -0.146303 -532 1 9.96619 2.7451 12.9133 2.94451 10.1866 18.8487 -533 2 9.87163 2.03702 12.2777 -5.79326 -7.02869 -14.8001 -534 2 9.15272 3.27293 12.9211 3.46257 -1.15836 -6.04557 -535 1 2.89008 8.93457 13.069 -0.378913 -4.03455 -0.489948 -536 2 3.23396 9.82093 12.8894 1.3587 3.50504 -2.14294 -537 2 3.63423 8.44035 13.4383 1.00579 -2.11175 -2.13579 -538 1 3.23705 8.4538 3.70316 6.66602 15.0067 -51.1451 -539 2 3.68898 9.21355 3.2191 -13.1992 -22.9024 22.1933 -540 2 3.37321 8.55056 4.62635 6.35333 11.1623 30.2444 -541 1 5.63533 7.19464 8.56829 15.13 5.19196 -11.3333 -542 2 5.75579 6.23215 8.63413 -6.09463 5.83127 4.58457 -543 2 5.06463 7.50349 9.27803 -5.30623 -7.19668 4.50769 -544 1 14.8805 1.37043 1.98087 -12.9306 20.6627 -0.801435 -545 2 14.4834 2.20569 2.28334 5.69168 -11.9007 13.5915 -546 2 15.1168 1.59638 1.09054 15.1066 -6.121 -14.4277 -547 1 8.35206 15.1867 0.801551 -2.76223 -14.7585 -5.29804 -548 2 9.12264 14.9643 1.32951 11.031 8.33032 8.58299 -549 2 7.67017 14.6008 1.15941 -5.63761 -0.337967 -3.00039 -550 1 15.5896 1.3528 7.2086 5.32958 13.3681 13.2076 -551 2 15.0272 0.817571 6.66531 -11.4451 -13.4108 -9.89715 -552 2 14.9993 2.0562 7.52457 4.21653 3.3566 -1.64766 -553 1 5.02591 13.0452 18.4884 -9.20414 -3.59717 -21.6247 -554 2 5.46138 13.1397 0.681872 7.63488 2.92653 16.7381 -555 2 5.72796 13.1696 17.8326 -7.15584 3.38504 4.08457 -556 1 15.3795 8.51367 18.1423 -0.613664 -0.0581633 13.6311 -557 2 15.7206 8.99589 17.3938 3.47957 9.7554 -12.9134 -558 2 15.3333 9.18442 0.205917 -4.60531 -6.1888 -2.54679 -559 1 12.0939 3.05244 18.336 -15.98 21.6351 4.66001 -560 2 12.5019 2.66242 0.476891 0.147771 -8.75739 -8.71627 -561 2 12.3559 2.60872 17.5248 9.46456 -12.7769 5.34739 -562 1 13.1875 12.6757 5.16147 -9.52799 6.20775 -2.46737 -563 2 13.6969 11.8811 4.95337 3.5398 -1.69434 3.58065 -564 2 13.2525 12.8475 6.11376 6.90446 -8.64397 -1.04625 -565 1 6.03627 7.1613 0.0926319 -1.4976 11.1377 0.14104 -566 2 5.76921 8.10211 0.154014 9.70457 -9.32393 -3.08293 -567 2 5.20613 6.68485 0.159604 -1.55619 -3.41243 3.21991 -568 1 17.685 15.9184 14.9825 -1.37425 0.537856 -17.3926 -569 2 16.8502 16.3506 14.966 -20.4161 12.6054 20.7942 -570 2 17.7239 15.7506 14.0369 24.1644 -10.6132 -5.26117 -571 1 13.1805 0.948047 16.6125 -8.26177 1.73564 3.5107 -572 2 14.0455 0.715926 16.9626 7.25254 0.595142 -3.17693 -573 2 12.7267 0.0993777 16.5408 2.533 -1.4889 -4.3323 -574 1 11.0204 14.5878 7.33132 -13.7805 -25.7938 -0.586216 -575 2 10.2983 13.987 7.62969 9.87943 15.8321 -1.01987 -576 2 11.8217 14.058 7.45361 -0.254224 3.6388 3.5388 -577 1 17.5119 8.53957 2.08465 9.75653 -12.9638 -10.6953 -578 2 16.6633 8.36471 2.52368 3.0717 -2.74041 -4.8374 -579 2 17.6343 7.8268 1.40004 -7.84255 17.4574 20.9547 -580 1 12.3495 7.93856 1.97915 15.2682 -24.1922 3.95646 -581 2 11.8245 8.73298 1.97607 -8.33179 10.3297 -5.28986 -582 2 12.0289 7.32679 1.29658 -2.64171 9.95394 1.06163 -583 1 11.9622 14.6462 10.3592 5.19436 44.1652 25.6085 -584 2 12.1561 13.8266 9.98193 3.67183 -41.4058 -22.2867 -585 2 11.0169 14.8072 10.2884 -7.2612 -3.28322 -4.25289 -586 1 6.85285 6.99572 15.5659 -14.0155 -24.0568 -12.8099 -587 2 7.75988 6.91015 15.2685 9.48733 7.04308 1.07731 -588 2 6.80041 7.76332 16.11 4.63477 18.9896 15.1539 -589 1 8.01222 4.65145 13.4113 -36.8067 -34.3033 -31.6859 -590 2 7.3316 4.83402 12.7007 16.1602 -3.60309 24.697 -591 2 8.38377 5.47541 13.6286 15.6027 34.5994 6.21753 -592 1 13.4241 12.174 14.3057 -4.84328 6.02619 2.2323 -593 2 13.1628 11.2453 14.2138 0.984992 -0.986947 -4.38535 -594 2 13.8661 12.446 13.4834 -0.550032 -4.72607 1.54363 -595 1 14.7341 9.44221 7.2791 -5.07947 3.15833 13.2143 -596 2 15.5444 9.94699 7.52972 -16.5583 -4.09464 -2.76463 -597 2 13.9842 9.66778 7.87655 21.0159 1.38057 -11.435 -598 1 12.706 16.9897 3.14089 12.6698 -33.6085 3.29803 -599 2 12.7844 17.2146 4.05845 5.40916 5.57996 15.4808 -600 2 12.1668 17.6603 2.78193 -20.8699 29.0634 -19.4792 -601 1 1.09001 7.14262 17.4001 -13.5934 2.13623 7.48936 -602 2 0.156991 7.24832 17.6908 14.7769 -7.58529 -2.77652 -603 2 1.13731 7.55625 16.5284 -2.3111 1.37932 -0.487878 -604 1 12.8562 5.06495 15.6988 -8.68567 -0.702669 -5.76624 -605 2 13.5471 4.4122 15.5538 8.1837 -6.12965 4.55719 -606 2 13.3218 5.91347 15.6395 -0.893164 2.09785 3.54679 -607 1 2.45402 3.36746 5.11563 -15.0026 -7.91555 0.636238 -608 2 1.84292 3.24382 5.86687 4.72922 -2.7794 -8.95345 -609 2 2.91216 4.18226 5.3072 9.55717 10.9124 5.44962 -610 1 8.31869 11.1649 13.5414 -26.3953 31.2189 -67.0184 -611 2 8.3305 10.9362 14.4299 14.6498 -23.9054 54.2316 -612 2 8.96182 10.7076 12.9898 15.0794 -7.45176 14.931 -613 1 12.9219 1.43726 13.3082 8.40674 -27.4269 12.3988 -614 2 13.6356 1.33586 12.6838 7.08718 -5.3 -10.143 -615 2 12.6036 2.28403 13.0872 -17.61 33.9058 -2.44667 -616 1 6.45277 13.6094 2.15178 17.7292 -13.553 0.669437 -617 2 5.88225 13.9257 2.84987 -12.2826 9.62032 8.12495 -618 2 7.05696 13.0019 2.62135 -3.25561 7.9246 -7.28354 -619 1 15.9319 6.53462 12.7261 -1.3149 8.22476 -13.019 -620 2 16.4256 7.00237 12.02 -4.18033 -7.18445 13.3481 -621 2 16.3662 6.74364 13.5705 0.249391 -3.37031 -2.78146 -622 1 16.8119 0.703827 9.59317 0.0549178 13.2549 -11.7388 -623 2 16.9772 18.4048 9.65541 -4.88295 -11.6626 5.05601 -624 2 16.4803 0.847119 8.68154 -1.08178 -1.2883 7.79904 -625 1 6.11652 11.6489 8.33522 -7.45125 2.78057 4.10213 -626 2 5.22601 11.4682 8.68918 7.08294 1.77705 -0.544493 -627 2 6.44454 10.7788 8.07724 4.19277 0.895061 -4.04259 -628 1 2.82334 8.71064 0.367814 57.5944 7.33247 25.2144 -629 2 2.2601 8.16366 18.5098 -36.527 -13.587 -20.7071 -630 2 2.37171 9.41868 0.829256 -17.9324 0.137834 -3.43482 -631 1 10.1122 10.4601 6.54653 2.23323 -6.08635 8.59596 -632 2 10.5188 9.74717 7.06727 -1.60105 2.20328 -1.71973 -633 2 10.6949 10.5759 5.79445 1.91861 -2.10956 -11.6412 -634 1 6.75321 15.7504 6.59889 15.4627 0.902891 -8.22878 -635 2 7.26857 15.9454 7.3825 -2.17992 1.48032 8.28293 -636 2 7.22097 16.2558 5.90647 -13.1985 0.138133 2.05084 -637 1 6.44152 13.0383 5.65846 10.3967 8.14078 0.466175 -638 2 6.75357 13.9433 5.8413 -7.70657 -8.59676 1.70002 -639 2 6.06189 12.7174 6.48437 -0.213232 -3.44089 0.434225 -640 1 16.7867 12.5398 9.78373 -0.895423 12.3409 14.8939 -641 2 16.908 11.9251 9.05274 5.68732 0.178616 -8.50939 -642 2 17.2058 13.3939 9.58039 -4.06144 -12.2084 -5.14549 -643 1 6.11722 2.93773 2.78358 1.28645 13.216 -7.71479 -644 2 6.25944 3.86133 2.4934 3.99356 -9.45804 11.966 -645 2 5.80949 2.50246 1.9813 -4.27697 -8.38821 -0.209888 -646 1 10.8697 3.19981 3.26527 3.50346 -2.80617 2.55973 -647 2 10.3917 4.00785 3.47818 -6.11785 -2.03152 -1.59068 -648 2 10.4869 2.83625 2.45753 -2.48553 0.910808 2.03729 -ITEM: TIMESTEP -50 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.80494 6.94654 17.8995 24.4982 -1.06408 -3.00226 -2 2 7.9626 7.14317 18.2754 -25.5132 0.779993 7.28642 -3 2 8.754 6.09075 17.4755 -3.81212 -4.80634 -6.17786 -4 1 18.7076 8.28828 6.77862 -17.6183 19.7289 -45.7057 -5 2 0.378325 8.05756 5.8509 -9.14495 4.02657 32.4311 -6 2 0.533056 7.77742 7.41073 20.0311 -22.8668 16.2585 -7 1 8.47587 18.7144 6.8555 -15.9357 -0.720841 9.56566 -8 2 9.33674 0.260611 6.50709 17.8925 2.772 -5.71063 -9 2 7.894 0.699709 6.41588 1.40147 0.745568 -0.352682 -10 1 6.55032 1.74908 11.6806 -30.6389 -0.0206495 8.42613 -11 2 5.72229 2.20254 12.0188 30.9536 -14.8428 -8.23206 -12 2 6.26581 0.83583 11.4478 2.55871 18.5754 3.76962 -13 1 7.01034 5.66598 2.40366 42.8029 -38.9731 -13.6875 -14 2 6.35895 6.02285 2.96016 -30.9745 25.4116 27.1882 -15 2 6.9342 6.07183 1.55014 -9.7244 15.1829 -13.9093 -16 1 16.2046 10.2277 16.1038 24.2393 -12.7483 3.49627 -17 2 17.1446 10.5017 16.2161 -25.4373 -4.23616 -6.12234 -18 2 15.647 10.9645 16.3441 -0.0961828 13.5193 2.91036 -19 1 10.6483 14.9468 2.32679 16.6528 15.7411 4.7381 -20 2 10.6274 14.3584 3.09768 -0.623134 4.2367 -1.18236 -21 2 11.2712 15.6715 2.59359 -14.1521 -13.9994 -5.33424 -22 1 17.1661 8.23718 10.6306 -11.2967 1.73071 14.301 -23 2 16.7507 8.8212 11.3018 1.93853 -3.53361 -12.158 -24 2 17.9019 8.73965 10.2686 8.0864 2.26419 -0.719652 -25 1 14.7146 15.8737 16.457 -21.3602 13.4439 -13.9077 -26 2 13.7676 16.1527 16.3582 25.6738 -5.80999 2.03747 -27 2 14.7447 15.4629 17.3289 2.78446 -2.53877 0.107495 -28 1 12.1127 13.3961 0.516068 7.29043 -9.0569 -3.36162 -29 2 11.9491 13.4845 18.198 -4.88029 1.64951 11.237 -30 2 11.4672 13.8878 1.04861 1.29785 5.2885 -8.15688 -31 1 9.32313 5.46813 3.97213 7.80738 6.41636 -30.8752 -32 2 8.77956 5.22076 4.69796 -14.0602 -7.63701 27.6376 -33 2 8.66617 5.58024 3.26537 2.47672 -2.22308 0.129141 -34 1 1.75935 4.12111 11.6197 18.1342 -37.205 15.7411 -35 2 1.54791 5.00495 11.8916 -2.97584 25.4072 4.68628 -36 2 2.32145 3.72177 12.3424 -17.0092 10.631 -21.3466 -37 1 2.03979 6.80407 8.28533 9.98525 11.4794 16.6393 -38 2 2.53906 7.28349 8.98677 -9.97253 -7.08615 -13.1486 -39 2 1.84044 5.93856 8.67612 2.99865 2.8006 -7.53122 -40 1 5.41368 4.4431 7.98609 2.04847 -7.17668 -5.4397 -41 2 5.52021 3.53426 7.6768 1.69988 -8.04832 10.7211 -42 2 4.8597 4.83563 7.32005 -13.574 8.98698 -13.1921 -43 1 3.28639 2.94557 17.481 18.7711 -22.2673 -22.0629 -44 2 3.9564 3.24513 16.8336 -6.74837 -1.29983 9.82734 -45 2 3.01936 3.73284 17.9334 -14.3576 17.7403 14.3716 -46 1 7.43065 5.38409 6.1108 -4.02947 -12.3157 -7.88053 -47 2 8.04294 5.88377 6.62432 18.8075 23.5792 8.00277 -48 2 6.91671 4.96856 6.79731 -10.3369 -11.1081 4.55684 -49 1 9.79016 6.98523 11.9902 -10.4204 5.88316 -11.2143 -50 2 10.3735 6.44493 11.4296 -8.50476 3.87141 4.17676 -51 2 9.02941 7.28204 11.4255 18.3189 -8.29917 9.01359 -52 1 14.0741 3.64931 8.08693 10.5401 -0.215179 40.0548 -53 2 14.0167 4.44403 7.56769 -3.75439 10.9765 -10.3635 -54 2 14.3054 3.9684 9.00291 -5.13065 -9.75311 -28.2231 -55 1 4.53282 17.2396 3.96388 -3.36194 -12.9595 16.5635 -56 2 5.47422 17.3897 3.95236 14.0752 8.1678 -3.62607 -57 2 4.10275 17.6636 3.22639 -0.935466 5.38311 -16.6052 -58 1 16.4462 16.5922 10.2581 -38.5234 -1.88036 17.4962 -59 2 15.5721 16.6729 10.7424 33.2408 0.640367 -11.4138 -60 2 16.1948 16.0519 9.4989 1.36351 -0.703045 -4.07641 -61 1 1.99534 4.82647 0.326236 -5.72725 6.00108 -15.6714 -62 2 2.53752 5.17962 1.03714 5.87953 4.50688 4.90779 -63 2 1.76739 5.60304 -0.220726 -2.02535 -4.08014 4.56707 -64 1 11.5531 13.2812 16.3325 -4.55485 8.80091 5.86354 -65 2 11.0534 12.4701 16.4457 -6.69668 -7.45166 4.31247 -66 2 12.0841 13.1031 15.5561 8.82157 3.01133 -6.78989 -67 1 10.1577 11.0139 16.8858 -24.3839 23.6532 0.592397 -68 2 10.5791 10.1721 16.8528 10.3809 -28.4273 -2.47871 -69 2 9.20446 10.8554 16.7431 9.15295 -0.788439 1.53623 -70 1 11.769 17.4436 13.4724 -4.31264 31.1905 -3.85112 -71 2 12.3451 17.016 12.8258 4.51875 -1.42135 -0.782751 -72 2 11.9049 18.418 13.331 2.02313 -21.8103 4.25856 -73 1 6.43699 9.33747 12.2016 -14.3685 16.3251 29.571 -74 2 6.95929 8.94901 11.512 13.8657 -1.33735 -10.2504 -75 2 6.99936 9.91985 12.7612 -5.52999 -10.4188 -15.163 -76 1 16.2506 12.8362 2.68463 10.4823 17.07 -2.68352 -77 2 17.0784 13.3466 2.55935 -9.20242 -14.0812 1.4249 -78 2 15.565 13.5285 2.65461 0.126865 -8.38924 5.57615 -79 1 0.688432 12.6159 5.91845 40.3739 4.73102 13.6953 -80 2 0.965548 12.5027 5.00914 1.60296 -4.44104 -10.7732 -81 2 18.4099 12.7183 5.90627 -44.0147 0.977299 -7.7541 -82 1 5.23962 16.4285 18.4285 2.37714 -1.84876 8.0205 -83 2 5.78786 15.7427 18.0572 3.65919 -12.8888 -12.968 -84 2 5.57695 16.4825 0.678793 -3.22986 7.92557 6.36641 -85 1 0.598604 7.70507 4.14138 -20.7786 -13.2635 7.16681 -86 2 18.6305 8.09263 3.50172 -0.345103 1.12768 -4.13337 -87 2 1.46117 7.8354 3.77399 24.2365 9.84596 -7.22116 -88 1 3.12664 8.94501 6.49467 58.7355 2.96877 -21.5552 -89 2 3.79065 8.46432 7.02112 -12.6266 6.35685 -1.15291 -90 2 2.29097 8.86083 6.88074 -41.9399 -6.12221 23.1652 -91 1 7.26988 10.3368 16.2836 11.5372 -0.463039 -18.2668 -92 2 6.61986 10.5879 15.6307 -2.48374 3.02842 -3.04887 -93 2 6.78814 10.3049 17.1036 -3.00573 -3.18181 16.2709 -94 1 11.123 0.978368 5.0094 -10.4546 8.12706 3.20432 -95 2 11.0717 1.86722 4.62246 7.34447 -2.45893 1.30193 -96 2 10.765 0.419141 4.31729 -2.84542 -7.68945 -6.73121 -97 1 4.36745 2.7997 13.2283 -2.96005 27.1446 -27.16 -98 2 4.67681 3.13482 14.0684 -0.492375 -1.19152 9.60175 -99 2 4.17697 1.87548 13.305 -2.22526 -24.419 13.8486 -100 1 8.37947 10.1962 1.80259 -4.93469 16.4683 -10.3397 -101 2 8.22749 10.8872 2.46356 1.16914 -1.49574 -1.6966 -102 2 8.71062 9.47199 2.30942 8.47484 -21.3721 12.0127 -103 1 10.3811 1.71408 15.5377 20.686 0.359172 -10.6925 -104 2 11.354 1.66546 15.4316 -15.8773 -5.06945 10.6173 -105 2 10.0964 2.02238 14.6685 -5.35844 0.742925 -2.36882 -106 1 2.68357 12.8347 7.81396 4.59418 8.51704 7.17464 -107 2 3.18489 13.5948 7.4697 -3.72618 -6.19027 -0.541735 -108 2 1.90686 12.7457 7.24856 2.42229 -2.05385 -5.50174 -109 1 3.74169 11.6981 5.12659 20.4064 16.2552 5.07347 -110 2 3.6031 10.8525 5.51837 -2.34348 -17.0347 14.1119 -111 2 3.05756 11.7956 4.48632 -17.1397 4.43934 -14.0111 -112 1 6.78306 14.4202 16.945 8.30127 18.455 -2.7408 -113 2 7.70256 14.7228 17.0235 -7.00262 -4.27134 -0.857039 -114 2 6.4289 14.8468 16.1479 2.30915 -9.19793 -2.69046 -115 1 14.2185 14.5268 3.31588 -23.2154 9.18115 10.9982 -116 2 13.6682 15.2954 3.06852 12.5657 -5.26706 1.63848 -117 2 13.7604 14.1667 4.10581 9.83524 -2.33371 -14.8176 -118 1 8.44676 18.1227 16.0393 7.73472 16.3177 -1.68025 -119 2 9.01165 17.3799 16.1525 3.2644 -34.6246 10.2309 -120 2 9.11477 0.14931 15.8801 -4.9724 20.6673 -2.43491 -121 1 4.70679 1.64341 4.91058 -17.3364 -32.3489 41.2122 -122 2 3.86106 2.04855 5.10849 -6.14561 5.35271 -2.51022 -123 2 5.03045 2.1011 4.1778 23.045 28.1017 -39.82 -124 1 14.9769 12.6712 16.4491 28.5182 -25.5733 -37.1858 -125 2 14.5585 13.1664 17.1249 -24.0861 16.0366 17.7329 -126 2 14.4092 12.4828 15.6576 3.30334 14.0855 25.2157 -127 1 15.7195 18.4537 16.8862 -41.4911 -4.79998 -47.5194 -128 2 16.474 18.4695 17.416 41.6971 -5.3201 37.0536 -129 2 15.5173 17.5216 16.6763 -0.165283 4.31671 10.9236 -130 1 1.26675 1.20722 16.5821 1.91531 -3.73727 -7.96899 -131 2 2.06576 1.68562 16.7995 9.77153 8.32265 -0.296149 -132 2 0.695796 1.45596 17.2985 -12.9769 2.74169 12.7471 -133 1 18.1595 4.46894 15.9392 -8.68238 9.49864 15.6389 -134 2 18.21 4.01948 15.1094 2.12602 -9.4702 -15.5502 -135 2 0.321646 4.30297 16.4236 6.52219 -0.344151 0.382064 -136 1 12.2433 16.9631 16.1365 30.1535 25.9085 -42.0202 -137 2 11.4764 16.7912 16.6244 -43.4812 -17.6238 21.6018 -138 2 11.9609 17.1491 15.2014 5.35486 -10.4534 20.1012 -139 1 16.0404 2.55502 18.1172 12.6912 -10.4842 9.42679 -140 2 15.6589 3.39683 18.3503 -6.59057 14.1496 4.33812 -141 2 15.9441 2.46009 17.1755 -7.16214 2.08136 -15.1428 -142 1 6.70635 13.8458 10.192 -16.5385 -19.5662 -16.6234 -143 2 6.46743 13.4829 11.0519 3.62966 4.37567 6.36784 -144 2 6.41781 13.1513 9.56037 11.5929 10.5707 5.5488 -145 1 10.1419 18.3987 2.73425 -19.4638 -25.4286 12.0097 -146 2 10.2073 0.494584 2.15475 6.00155 18.7458 -18.7245 -147 2 9.2799 18.0069 2.48337 13.6051 6.39322 6.25061 -148 1 3.04438 17.7185 6.11283 5.61436 7.93422 -10.0091 -149 2 2.18521 17.5434 5.71014 -2.22655 1.93918 -4.29169 -150 2 3.60431 18.0006 5.35738 -6.06642 -9.44159 14.8188 -151 1 12.59 16.8727 7.99688 3.41749 0.26688 0.968442 -152 2 11.9163 16.1959 7.96054 -9.29683 -10.0995 -8.1817 -153 2 12.3648 17.371 8.78825 5.01363 9.11979 0.25951 -154 1 14.8925 15.2941 8.21002 11.8118 0.190541 -21.4145 -155 2 14.0466 15.7377 8.15471 -7.99071 7.70949 7.81769 -156 2 15.2804 15.4945 7.32486 -0.0803457 -7.85257 22.8773 -157 1 17.7158 18.2428 0.330134 42.1686 22.2301 9.80157 -158 2 18.5718 17.7519 0.320787 -20.6577 0.0591745 -9.59458 -159 2 18.0296 0.514827 0.540707 -19.3386 -19.3229 -5.27308 -160 1 0.848087 10.4587 1.36302 27.1846 51.9138 -28.6855 -161 2 0.125428 9.973 1.66463 -44.0007 -34.6793 17.9508 -162 2 0.450253 11.2027 0.827225 17.544 -22.8417 14.6566 -163 1 1.73752 12.2317 3.35921 -10.6222 -3.23772 -40.3174 -164 2 1.50468 11.5771 2.65039 3.80547 3.73659 24.0112 -165 2 1.78112 13.0447 2.82871 4.93945 -0.670418 11.0651 -166 1 0.61763 17.2312 4.89977 -31.3278 9.09129 49.7394 -167 2 18.753 18.067 4.93438 12.2337 -8.61092 -13.4292 -168 2 0.309388 16.8063 5.75223 19.8395 0.744545 -34.548 -169 1 1.12081 0.925337 9.40389 -12.5044 -10.6635 0.652446 -170 2 1.34187 0.581545 10.2981 -6.32089 4.74016 -12.6461 -171 2 0.253358 0.524348 9.17819 18.5788 9.22491 5.8567 -172 1 16.7331 2.36195 13.2995 -4.07693 -18.6231 24.2357 -173 2 16.9587 2.56306 12.4093 5.05193 8.99127 -27.3142 -174 2 16.5121 1.41005 13.3069 2.86591 9.33714 2.00751 -175 1 2.6752 15.8404 12.084 -17.9655 13.8891 -13.7444 -176 2 3.1007 15.4046 12.7977 10.8605 -10.5552 20.9848 -177 2 3.18035 15.6022 11.2985 0.61387 1.79975 -2.62876 -178 1 16.4324 15.6688 6.07894 -11.0906 -29.1832 8.11987 -179 2 17.3135 15.6699 6.4691 2.82688 3.86386 -3.5648 -180 2 16.3493 16.3586 5.42897 4.86465 16.2346 -9.8305 -181 1 5.78229 5.11191 11.8099 -13.8406 10.2937 3.29755 -182 2 5.26053 5.84491 12.2174 12.8802 -11.8636 -2.84442 -183 2 5.17337 4.36282 11.7377 2.58239 3.92087 3.15374 -184 1 15.1463 4.86734 0.794152 0.864651 12.4924 -33.9562 -185 2 14.9842 4.50309 1.65022 -3.17819 -5.74322 26.2661 -186 2 14.3662 5.39647 0.571272 5.91156 -4.56503 2.45287 -187 1 16.3343 16.3902 2.05204 -8.53913 3.9795 31.3204 -188 2 16.0972 16.7844 2.93864 3.99019 -13.2916 -26.145 -189 2 16.6713 17.1379 1.5654 4.18336 9.27065 -12.2854 -190 1 0.251768 4.84384 3.8243 -5.07672 -49.1083 -0.618349 -191 2 0.303365 5.75864 3.98841 7.12191 44.1717 7.46524 -192 2 0.849427 4.39339 4.43966 -1.76195 8.48948 -7.42491 -193 1 2.97026 15.0637 15.1648 0.961584 14.1925 -19.6325 -194 2 2.86359 14.8338 16.0871 -5.01806 -10.0022 10.5852 -195 2 2.57214 15.9549 15.1104 2.70735 -9.48442 0.706884 -196 1 1.14871 14.6442 9.53518 -42.8529 -19.211 3.24989 -197 2 2.06628 14.849 9.52706 28.3433 -3.949 4.37311 -198 2 1.01023 13.7361 9.90627 12.772 19.4662 -8.86837 -199 1 13.5229 16.5669 11.532 20.3549 -23.4698 16.7524 -200 2 13.3606 17.2446 10.8944 -12.6142 15.9017 -14.8664 -201 2 13.2357 15.729 11.1267 -5.06335 10.0173 1.96475 -202 1 4.64907 1.44855 0.782556 14.1843 16.2277 -15.4645 -203 2 4.13811 2.00007 0.175187 -1.198 1.13782 0.731863 -204 2 4.05002 0.760268 1.05534 -6.36237 -9.04178 10.9284 -205 1 1.45269 18.5669 11.8512 9.08594 -18.5638 20.5671 -206 2 1.3209 0.513151 12.6112 1.192 -1.45307 -0.682323 -207 2 1.82538 17.7349 12.2384 -6.22294 17.2853 -13.4176 -208 1 11.5083 10.14 3.99231 -12.3356 -6.67004 24.2683 -209 2 11.3008 10.4626 3.12291 -1.30093 6.41155 -12.7666 -210 2 12.4624 10.1697 4.04844 12.7044 -2.53047 3.95194 -211 1 8.22637 12.1595 3.70182 22.1984 -6.43536 -24.1249 -212 2 9.06359 12.543 3.994 2.39995 3.52197 1.898 -213 2 7.64229 12.2644 4.4292 -22.7553 4.87752 31.4773 -214 1 14.5041 4.04055 3.28708 -18.3332 1.47774 -0.327682 -215 2 14.9873 3.94029 4.11097 10.9182 2.80533 4.02706 -216 2 13.7169 4.55783 3.53097 2.05743 -3.46177 -0.871318 -217 1 5.62743 1.64825 7.52429 33.006 28.3977 -54.9531 -218 2 5.01294 1.12929 7.98513 -35.2623 -28.0367 23.7041 -219 2 5.43705 1.49837 6.5464 4.70081 6.15592 32.4881 -220 1 17.8649 1.10253 4.84999 -3.85271 -3.04411 9.89583 -221 2 18.5316 1.48406 4.28754 10.0589 0.579138 -13.4652 -222 2 17.9089 1.63153 5.65146 -2.44801 0.268727 5.2117 -223 1 6.82865 9.41118 4.50161 13.9732 -1.80028 18.7676 -224 2 6.94383 9.68391 5.43824 -8.65407 -5.40133 -16.2957 -225 2 7.70845 9.07477 4.25578 -5.27921 1.965 -0.840285 -226 1 2.66065 14.8943 1.98186 -2.57221 -9.24308 25.7982 -227 2 3.31586 14.7955 2.69868 -8.68087 -2.61777 -7.29774 -228 2 3.12007 15.367 1.30687 7.03004 7.53846 -18.6884 -229 1 17.3318 12.9277 13.2024 14.566 -8.41998 -6.98679 -230 2 16.4646 13.2932 13.3909 -3.11164 10.4066 0.365823 -231 2 17.9245 13.6681 12.9725 -15.6789 -3.68206 1.74475 -232 1 14.9332 10.5631 1.42248 26.9386 23.5346 15.1493 -233 2 15.5074 11.3103 1.7869 -22.4798 -24.8917 -12.2482 -234 2 14.0193 10.8096 1.5708 -2.19259 1.9486 -0.294463 -235 1 5.71089 6.73608 4.5629 -4.22281 28.118 -3.03355 -236 2 5.94827 7.69445 4.64343 -4.82413 -18.183 -7.3163 -237 2 6.31292 6.28304 5.16113 4.14578 -2.25186 0.1588 -238 1 7.97883 8.3192 10.3001 7.8407 -5.86676 -34.7961 -239 2 8.53275 9.01778 9.91692 4.61581 1.53144 9.76809 -240 2 7.67805 7.86001 9.48783 -4.88471 -0.599295 18.8237 -241 1 13.4226 18.4487 5.72909 4.08913 1.21656 -6.98532 -242 2 12.585 0.250804 5.52036 7.76092 4.80861 -0.84516 -243 2 13.2097 17.9386 6.50687 -2.642 -10.6174 11.5339 -244 1 0.0869602 2.62265 0.223952 -9.8031 -15.3274 -6.51765 -245 2 17.9117 2.88521 18.4333 -9.97249 -6.92357 5.22107 -246 2 0.604672 3.41479 0.198655 20.2406 16.0872 6.75582 -247 1 12.7806 11.0275 9.75202 47.836 -29.2198 23.6504 -248 2 11.892 10.9606 9.4924 -44.5823 -3.62186 -10.7645 -249 2 12.9839 10.1194 10.1272 -4.83434 23.2951 -13.1663 -250 1 0.705171 12.1501 11.0469 -11.5221 2.5881 -10.739 -251 2 18.3743 12.1368 11.1638 13.8029 4.27958 5.25964 -252 2 1.13401 12.4861 11.8379 -3.00537 2.27024 12.2218 -253 1 5.1174 7.31342 13.4172 11.1181 3.69095 0.765545 -254 2 5.61979 7.99643 12.9358 -2.94992 -2.73128 4.30069 -255 2 5.6521 7.15272 14.218 -5.77355 -1.15348 -7.33249 -256 1 1.197 6.86571 11.8595 38.3077 26.916 14.5555 -257 2 0.451078 7.27927 11.4324 -8.7071 4.85333 -5.01967 -258 2 1.83731 7.62187 12.0983 -31.0022 -32.2106 -6.42275 -259 1 15.4885 9.63727 12.3206 16.478 -29.8614 -10.1392 -260 2 15.1661 10.5006 12.1398 -12.0715 29.4427 -0.903292 -261 2 15.2587 9.41843 13.2151 -2.74274 1.51694 14.7591 -262 1 16.5678 12.6919 5.49509 2.68502 5.28083 21.2685 -263 2 16.324 13.6184 5.59953 -0.326156 6.48336 2.9395 -264 2 16.4016 12.5196 4.57887 -2.84479 -5.20052 -25.0662 -265 1 6.28213 9.87258 0.0490999 16.8985 1.83912 15.6964 -266 2 5.56262 10.3905 0.421328 -3.89363 2.12479 6.12138 -267 2 7.01982 9.90555 0.722608 -19.7924 2.8001 -17.1777 -268 1 12.2865 6.1036 4.06304 19.2748 24.5544 -29.5048 -269 2 12.3306 6.8161 3.36437 1.4085 -17.3408 22.8012 -270 2 11.3814 5.83426 4.0192 -21.2841 -11.2083 4.33393 -271 1 0.298047 12.7955 0.166375 -3.43648 3.64279 0.0778505 -272 2 -0.0290314 13.4316 0.817326 3.1389 2.62115 2.93426 -273 2 18.4391 12.9788 18.0124 -4.25126 3.67416 -7.60949 -274 1 3.647 18.6117 8.59889 -15.5834 11.8668 6.1299 -275 2 3.50703 18.267 7.70639 0.18727 -3.89186 2.0216 -276 2 2.76186 0.338497 8.83167 17.7751 -6.65964 -2.12733 -277 1 7.50606 17.376 4.49824 -10.0508 -46.4512 11.7168 -278 2 7.49016 18.3059 4.51667 7.03352 43.591 -0.815572 -279 2 7.72157 17.1186 3.60818 -1.05523 3.68228 -12.2984 -280 1 9.25162 17.1195 12.2401 -20.7119 -1.17481 -13.1138 -281 2 9.34873 16.3083 11.723 0.965197 -1.09758 -0.258815 -282 2 10.0653 17.2534 12.7074 19.1017 -2.42392 11.5163 -283 1 13.35 12.9891 7.98546 26.3101 20.7404 -8.62941 -284 2 13.4089 12.1901 8.49273 -4.66259 -15.0904 10.7497 -285 2 14.2093 13.4501 8.17144 -24.2961 -0.252284 -5.87391 -286 1 14.9018 2.99422 15.3537 -18.6075 -8.06583 14.6174 -287 2 14.2375 2.30647 15.2045 2.81445 1.4476 3.5012 -288 2 15.4631 2.94521 14.5905 14.0528 3.89371 -13.7736 -289 1 9.86333 15.5824 16.9775 -1.70109 -0.0675876 9.27141 -290 2 10.3396 14.7637 16.7526 0.856458 3.65656 -1.57854 -291 2 9.55317 15.4797 17.8978 1.12056 -0.962034 -11.839 -292 1 11.2957 8.40029 16.577 -16.0633 -20.1101 7.86553 -293 2 10.6817 7.8482 16.0424 7.68237 12.4971 4.88138 -294 2 11.3251 7.92133 17.4322 4.78934 8.39937 -13.6138 -295 1 3.89281 18.1695 16.7848 -3.14598 -18.8551 -14.8366 -296 2 4.41813 17.5168 17.2844 -2.97968 13.5676 2.86087 -297 2 3.87713 0.360621 17.2331 6.32956 9.89438 13.0847 -298 1 2.18947 4.17934 8.91366 -18.0693 4.35017 -17.8699 -299 2 3.09766 4.08917 8.6846 23.1764 -2.78898 -7.58361 -300 2 2.16493 4.06394 9.84833 -5.05649 -4.17918 28.8808 -301 1 9.87375 10.372 9.69798 10.3489 -25.1121 17.1783 -302 2 9.47622 11.1704 9.40878 -10.9495 28.2307 -13.2887 -303 2 10.0218 10.4724 10.6474 2.61027 -3.39635 1.23761 -304 1 9.66501 0.904023 10.8717 -13.0386 -22.5074 -9.87351 -305 2 9.3051 0.0213231 11.0865 8.01248 8.88818 8.11202 -306 2 9.06191 1.19139 10.169 9.00305 9.82525 0.172013 -307 1 9.18563 15.0903 10.2115 17.1556 13.6164 1.72702 -308 2 8.73275 15.8289 9.78742 -0.477718 6.62954 -2.89772 -309 2 8.53792 14.3995 10.1946 -15.8858 -12.7719 2.13472 -310 1 0.946133 9.58267 10.2797 -17.999 7.07835 7.04569 -311 2 0.977457 10.4775 10.6382 -6.96742 -0.068666 -4.76802 -312 2 1.85682 9.38261 10.1843 21.4216 -13.3352 -8.00245 -313 1 16.9414 4.83421 8.13223 15.4014 12.0295 -27.8426 -314 2 16.4342 5.57084 8.44793 -11.0978 12.5109 2.31217 -315 2 16.8158 4.17203 8.77314 -2.49922 -25.6846 24.7871 -316 1 14.7535 14.7061 0.203986 15.073 4.98951 -2.11802 -317 2 15.1043 15.2916 0.890887 3.3452 -1.27018 2.88153 -318 2 13.9621 14.3164 0.552408 -18.4772 -7.94901 9.40987 -319 1 3.67958 11.0243 9.53991 2.98139 -0.929731 17.0732 -320 2 3.55398 11.294 10.4695 5.20942 3.18167 -4.3207 -321 2 3.23108 11.6955 9.00414 -3.72853 0.365488 -5.84942 -322 1 11.2021 10.759 1.44219 -17.3262 -13.0718 -7.65614 -323 2 11.58 11.5828 1.16251 10.55 19.7497 -9.01804 -324 2 10.309 10.7579 1.05212 6.07305 -2.69648 6.21388 -325 1 13.1662 7.17502 12.7531 25.9391 -3.29657 1.887 -326 2 14.1362 6.96154 12.7671 -19.0435 5.16748 0.470499 -327 2 12.7272 6.32599 12.8606 -4.03684 -6.30893 0.442018 -328 1 9.61497 1.86018 0.978015 -9.58691 9.0933 -29.7593 -329 2 8.82052 1.59363 0.443821 14.7013 3.9795 16.3864 -330 2 10.1598 2.41617 0.376969 -4.12787 -12.2318 8.97473 -331 1 10.6544 13.5231 4.58863 -13.6132 -6.73185 -2.44549 -332 2 11.4017 12.9559 4.77554 12.969 -5.04099 -4.5155 -333 2 10.624 14.0848 5.36102 -2.93668 8.13722 11.8558 -334 1 14.451 1.77042 10.9566 -5.06993 -21.3108 1.92478 -335 2 15.2282 1.34301 10.5576 -2.05514 6.77792 0.416034 -336 2 14.5487 2.7176 10.8324 3.84606 4.21375 0.609558 -337 1 14.5616 12.2019 11.6619 17.6804 1.81894 22.1071 -338 2 15.3038 12.427 11.1092 19.6924 5.46932 -2.69443 -339 2 13.8862 12.1117 11.0284 -35.3643 -9.54852 -21.0379 -340 1 8.20666 5.07147 9.84086 19.0973 -30.0877 -21.2342 -341 2 7.45963 5.1784 10.3955 -25.2729 10.7477 18.5337 -342 2 8.15765 4.10536 9.6198 7.47394 24.0469 -0.436218 -343 1 1.5637 16.9015 18.3956 -12.4387 -25.8837 12.5929 -344 2 2.10927 17.2609 17.7108 10.7809 10.3745 -20.1818 -345 2 1.47705 15.9462 18.1578 7.28008 19.3441 8.23831 -346 1 1.51254 17.2865 15.33 -55.1424 19.1245 13.5119 -347 2 1.44158 18.2256 15.6397 11.4216 -23.3977 -5.64032 -348 2 0.55797 16.9673 15.4072 37.0312 4.44622 -8.61518 -349 1 3.63692 5.75726 6.07961 7.7365 -18.3794 -8.43759 -350 2 3.1745 6.31944 6.69962 -9.61621 11.1355 4.40451 -351 2 4.08899 6.28836 5.40075 -0.121738 1.87808 9.22135 -352 1 12.4625 9.47055 14.2033 -9.88788 31.7301 7.89028 -353 2 12.9131 8.72585 13.8435 10.9703 -26.4307 -11.7769 -354 2 12.2412 9.2145 15.1039 -0.841012 -4.82452 5.58465 -355 1 4.05279 15.2823 6.91192 -35.0907 -10.5097 14.3913 -356 2 3.49702 16.0377 6.67476 5.8423 0.670453 -1.17602 -357 2 4.92638 15.5321 6.67665 32.7349 8.37925 -5.72993 -358 1 0.666426 8.62945 15.01 -4.81633 6.31993 2.8284 -359 2 0.390025 9.55783 15.0778 2.6081 -0.187855 1.05312 -360 2 1.36445 8.64555 14.3512 6.1817 -1.74341 -6.99991 -361 1 12.9834 8.27358 10.2916 -19.5051 6.59204 10.6567 -362 2 13.6375 7.73399 9.85191 12.7638 -5.94229 -3.5145 -363 2 12.8815 7.86968 11.1799 4.96282 8.38227 -11.7258 -364 1 15.3269 7.75333 3.56288 29.5219 38.2257 -22.8776 -365 2 14.5855 7.35684 3.13467 -21.9298 -17.371 4.59449 -366 2 15.5403 7.50003 4.45743 -10.8574 -16.6026 13.017 -367 1 17.2887 6.69393 0.021468 15.5778 -19.6292 8.74644 -368 2 16.7574 5.92192 0.248673 1.14134 -1.83764 1.32773 -369 2 16.6558 7.32534 18.3698 -22.9594 20.3863 -6.57681 -370 1 8.86981 6.94597 7.81474 24.2415 27.8548 -9.55577 -371 2 9.77577 7.36617 7.90295 -24.2622 -15.8521 -2.69303 -372 2 8.7837 6.29392 8.50186 -0.35036 -13.7271 19.3897 -373 1 12.3819 0.576227 1.23609 4.50683 -3.19553 -2.96149 -374 2 13.3476 0.534404 1.26268 -2.04299 5.45052 6.49319 -375 2 12.129 0.50298 0.316799 -1.00379 -2.5807 -2.54403 -376 1 5.62478 15.1294 14.5559 -8.95515 -20.8805 6.21096 -377 2 4.66749 15.251 14.733 11.0075 0.339747 -2.61971 -378 2 5.99586 15.9305 14.1948 2.79164 18.0184 -3.26028 -379 1 3.86891 6.41255 1.75203 -0.0773217 -5.81596 13.5476 -380 2 3.55695 7.28194 1.50076 -6.60469 12.2107 -8.14743 -381 2 4.09127 6.52195 2.68979 -0.816275 -1.80663 -6.76426 -382 1 3.9342 11.5843 12.3776 -18.6931 -4.72392 -0.912594 -383 2 4.79227 12.0122 12.4616 2.30575 0.246561 2.78418 -384 2 3.29871 12.1178 12.8946 9.72132 -5.51488 -9.32366 -385 1 5.32882 3.8676 15.8786 0.594801 -80.2026 -15.123 -386 2 6.00417 3.18473 15.5574 -21.0433 25.388 14.8589 -387 2 5.72544 4.69544 15.8213 26.1638 51.9163 -2.72297 -388 1 14.3304 10.2034 4.48175 -27.4096 24.8129 53.7077 -389 2 14.5884 9.79586 5.33863 -8.33179 4.59428 -12.4543 -390 2 14.8538 9.80174 3.84099 29.6706 -27.6476 -38.9945 -391 1 7.77951 17.4021 9.16969 8.83259 -7.31352 -4.45478 -392 2 6.90706 17.6601 9.4324 -15.0276 -0.0996042 12.8709 -393 2 7.95009 17.9588 8.40488 9.49987 1.3194 -6.72214 -394 1 4.51552 14.5162 3.99356 4.98181 -4.90212 -22.3913 -395 2 4.52626 15.4247 4.27156 -0.518589 17.7617 2.00307 -396 2 4.31207 14.0204 4.77138 -3.57212 -17.3619 18.7252 -397 1 14.1875 7.4375 15.7998 -22.901 -10.8896 -16.0938 -398 2 15.1146 7.35808 15.6286 24.9688 -1.25651 -4.60954 -399 2 14.1131 7.89225 16.6248 1.32628 8.65776 19.0596 -400 1 2.98527 18.3068 1.9119 -4.72699 -30.9822 -37.1172 -401 2 2.49826 17.7826 1.20191 12.7581 13.6458 27.4428 -402 2 2.34371 0.225349 2.32895 -15.9948 14.8465 9.72817 -403 1 8.01181 1.59883 4.56348 -29.7821 5.07108 -10.5683 -404 2 7.46781 2.03632 3.88017 -2.37558 -3.45248 10.775 -405 2 8.87859 1.65459 4.20584 24.9106 -1.40589 -4.13938 -406 1 2.43696 14.1424 17.6778 32.6678 8.55365 0.150748 -407 2 1.74447 13.6484 18.0869 -17.757 -15.5673 8.49591 -408 2 3.25626 13.7213 18.0204 -5.64692 6.54589 -2.94203 -409 1 0.856601 1.76819 13.8909 -34.0133 7.6587 12.0684 -410 2 0.79549 1.64555 14.8654 10.1884 -1.39389 -18.6264 -411 2 18.5699 1.97567 13.6249 24.5068 -3.80874 6.24474 -412 1 4.3972 0.0813689 13.9033 -13.8751 0.78744 16.7708 -413 2 5.2251 18.2898 13.7459 20.8939 -4.75733 -3.28132 -414 2 4.21678 18.5292 14.8441 -3.95615 2.50922 -10.6456 -415 1 7.163 0.723926 18.3524 28.8431 -20.8152 -22.3389 -416 2 7.29578 0.265373 17.4701 -6.89821 16.5948 25.8874 -417 2 6.28988 1.09447 18.4079 -18.4483 2.86302 0.00697782 -418 1 16.0461 18.4126 13.9592 23.9709 4.87143 24.0859 -419 2 15.127 18.3862 13.8391 -39.1169 -4.38354 -15.9017 -420 2 16.1011 18.5404 14.9193 8.5862 0.360016 -3.75437 -421 1 10.1416 4.5234 16.2814 33.6533 37.5162 -8.59515 -422 2 11.1148 4.69187 16.0483 -33.0569 -13.9639 15.4314 -423 2 9.96481 3.59397 16.253 2.9151 -23.0089 -4.34536 -424 1 15.9284 17.7644 4.42623 32.451 -11.9188 -9.4973 -425 2 16.5348 -0.134683 4.55752 -3.00893 1.73986 -2.0661 -426 2 15.0985 18.0471 4.75447 -36.3204 13.6328 11.8833 -427 1 7.01478 17.4412 13.8546 -37.2955 -8.85564 -21.6385 -428 2 7.52749 17.7553 14.5758 15.4879 9.12118 24.9138 -429 2 7.64547 17.2338 13.1683 11.7367 1.38126 -7.54157 -430 1 13.2517 6.48941 6.59541 21.6379 18.6409 -4.45059 -431 2 14.0732 7.02646 6.4901 -17.572 -15.5204 8.29538 -432 2 12.9904 6.33391 5.6816 -8.39128 -3.46546 0.217322 -433 1 7.82903 2.34082 9.30706 0.848413 1.46751 38.8479 -434 2 7.32489 2.17899 10.1397 9.78087 5.93227 -12.3925 -435 2 7.21411 2.12937 8.62642 -15.7826 -8.09866 -24.9258 -436 1 15.1931 14.7992 13.6996 5.60594 -14.9485 0.236255 -437 2 14.8724 15.0774 14.5533 -1.16755 2.2837 13.7936 -438 2 15.0044 15.5062 13.0994 -6.5851 10.7381 -11.5383 -439 1 9.39722 8.31385 3.80437 -4.07127 17.2834 -4.44624 -440 2 10.2713 8.68973 4.00761 -3.0526 -2.08627 -0.470344 -441 2 9.46128 7.36215 3.86627 5.27028 -8.92187 3.93672 -442 1 17.7859 13.5845 16.3834 -19.0466 -29.0207 18.2461 -443 2 16.8295 13.3731 16.3512 7.31415 3.8698 0.00611806 -444 2 17.8697 14.4051 15.917 1.12921 18.7325 -11.1152 -445 1 4.94376 10.5922 2.82245 -18.0715 22.8685 -14.9529 -446 2 5.66076 10.3167 3.37377 16.0421 -11.7082 13.1735 -447 2 4.72943 11.4907 3.12728 0.871258 -13.2337 -1.99455 -448 1 3.75648 8.36099 10.0882 -2.83158 17.8244 -9.78689 -449 2 3.88314 9.30809 9.8443 -3.15161 -16.2727 -0.870444 -450 2 3.74879 8.36585 11.0419 0.849549 -1.60464 13.0402 -451 1 15.9818 6.99244 6.07768 -13.3688 18.7296 1.03973 -452 2 16.7792 7.41732 6.38792 13.9106 3.61693 3.9934 -453 2 16.2026 6.08994 5.88298 6.53831 -20.9898 -2.75314 -454 1 15.1161 7.11481 9.04764 0.565665 -31.7989 38.5144 -455 2 15.8028 7.45918 9.62834 5.57768 4.61323 -0.34974 -456 2 15.1416 7.62578 8.27782 1.5606 28.4329 -39.6698 -457 1 6.26636 12.9592 12.746 15.2088 -10.2167 -2.30532 -458 2 7.09456 12.5046 12.9751 -5.12301 -5.10662 -0.512627 -459 2 6.13107 13.5604 13.4742 -6.25916 17.1748 9.55337 -460 1 12.1295 4.51914 13.098 -40.0586 -31.7334 -0.542355 -461 2 12.3128 4.55827 14.0372 7.66008 7.87672 6.17129 -462 2 11.3118 3.91999 13.0515 32.2373 26.2449 -7.62055 -463 1 11.3854 8.14886 7.92202 -18.4022 6.94815 -10.6415 -464 2 11.9487 7.53516 7.44565 12.5498 -6.92106 -4.31871 -465 2 11.7891 8.26504 8.77918 7.07043 -0.608458 13.7447 -466 1 17.1486 10.8722 7.52372 -29.3422 15.2924 19.4167 -467 2 17.741 10.1746 7.28593 21.144 -15.6164 -13.9006 -468 2 16.9754 11.4691 6.78151 4.60435 -5.53137 -7.06809 -469 1 5.26553 18.1239 10.9774 20.3802 -2.13667 -3.01104 -470 2 4.75345 17.8709 11.7323 -12.4512 -5.88679 12.7575 -471 2 4.64325 18.2391 10.2688 -13.5246 2.23536 -17.92 -472 1 7.60715 17.4884 1.7834 -2.49749 -8.82149 -34.1915 -473 2 7.92668 16.7242 1.2322 -11.5566 19.54 16.0619 -474 2 7.18999 18.106 1.13139 15.7932 -7.79309 14.6318 -475 1 1.92845 12.8983 13.5911 -4.1829 -6.61346 -8.43532 -476 2 1.49445 12.3761 14.2737 -4.42561 -3.96966 1.7572 -477 2 2.30088 13.6477 14.0465 3.83448 15.9215 12.3791 -478 1 9.57624 6.80131 14.8487 2.82943 -31.3701 -0.177857 -479 2 9.74438 5.86263 15.1368 -4.04832 25.5486 -0.431769 -480 2 9.80341 6.81631 13.907 0.113844 6.0265 -0.426062 -481 1 15.2789 4.31862 10.7553 12.937 12.8557 31.6205 -482 2 16.1415 3.96953 11.0436 -5.39931 0.983411 -21.2391 -483 2 15.1479 4.98349 11.4601 -8.5537 -3.88808 -14.9921 -484 1 11.2581 6.18474 0.159508 31.1076 25.8623 9.85053 -485 2 11.549 5.31982 18.5294 -8.46095 -20.0483 -6.31791 -486 2 10.3153 6.29854 0.132928 -17.8901 -6.88616 -7.00405 -487 1 -0.015613 11.3989 15.0155 5.52071 0.0143375 15.3818 -488 2 18.1286 11.6803 14.2478 -6.84029 3.18322 -8.47428 -489 2 -0.24984 12.0811 15.6717 7.42423 -4.02873 -7.86488 -490 1 7.04792 9.26093 7.28081 24.8295 12.5521 -3.74072 -491 2 6.59027 8.49663 7.6071 -13.7147 -18.0719 7.78469 -492 2 7.98742 9.01504 7.31689 -8.33941 1.9664 -1.88331 -493 1 18.3308 15.3469 12.3202 -6.03602 -2.26652 6.8961 -494 2 0.60478 15.4762 12.0772 12.6515 4.5696 -6.24084 -495 2 17.7927 15.7945 11.6538 0.941578 1.81095 -5.33876 -496 1 16.5149 4.38922 5.26132 -0.591505 19.7601 -54.4807 -497 2 16.8056 3.98806 6.0517 15.8153 -15.5532 32.6352 -498 2 17.2724 4.45951 4.61195 -16.46 -3.71476 24.2381 -499 1 17.705 3.15738 10.7395 -3.58994 -28.0349 -4.43916 -500 2 -0.0357658 3.31586 11.0143 13.799 7.93723 3.46651 -501 2 17.7252 2.25587 10.3433 -5.09014 14.337 3.42017 -502 1 12.282 -0.0102014 10.1171 1.80463 -26.6374 -6.99772 -503 2 11.3739 0.250254 10.2263 -16.4794 9.03176 6.86793 -504 2 12.791 0.759276 10.3145 17.2573 22.9944 3.87451 -505 1 10.3906 9.77529 12.4736 -11.6246 -18.6488 -11.2601 -506 2 11.1162 9.76462 13.0993 9.33947 3.77576 6.26492 -507 2 10.2448 8.81959 12.3007 0.540403 13.8663 1.27912 -508 1 0.620737 2.80838 7.04076 1.85552 -26.9198 -9.07562 -509 2 0.56001 3.58776 7.58035 -0.0658531 10.9425 14.6075 -510 2 1.10446 2.13014 7.5549 -9.15748 13.0523 1.42789 -511 1 0.330306 15.2957 6.90187 -7.34135 39.0889 57.248 -512 2 0.64916 14.9551 7.78023 -6.58887 6.78122 -17.5325 -513 2 0.549392 14.6745 6.26262 18.9985 -47.7984 -33.3782 -514 1 17.0475 6.9988 15.1595 3.61332 2.27156 3.35689 -515 2 17.7695 7.63103 15.0486 -1.58895 3.22527 -3.41358 -516 2 17.4554 6.32111 15.7084 -3.97121 -9.30147 -1.03946 -517 1 9.1229 12.4841 8.04245 42.4716 -17.0961 -6.2748 -518 2 9.3803 11.751 7.44403 8.89783 14.9312 6.88846 -519 2 8.20686 12.4452 7.97952 -55.5673 6.80073 1.54221 -520 1 1.25348 1.79037 2.92813 -6.45569 8.99744 5.64127 -521 2 0.618969 2.05555 2.26044 -0.811293 0.804254 -10.1384 -522 2 1.53437 2.62736 3.32834 8.32683 -8.65344 1.50874 -523 1 4.08283 15.132 9.84955 18.6585 -7.67887 -4.13383 -524 2 4.13303 15.3467 8.91064 -4.64689 1.73023 -5.13685 -525 2 4.95775 14.7288 10.0227 -10.2431 6.10486 1.39562 -526 1 7.30601 2.19422 14.6517 -6.95706 -8.0865 3.71032 -527 2 7.17746 1.61632 13.8834 -0.940722 6.01065 3.73041 -528 2 7.50104 3.06853 14.3169 9.18921 6.42869 -7.97623 -529 1 18.506 14.6308 2.17255 -30.1365 -0.614545 -1.61255 -530 2 0.727688 15.0378 2.26332 7.05 8.92743 1.17189 -531 2 17.7886 15.3173 2.20949 19.3309 -8.24877 -2.15246 -532 1 9.97566 2.72581 12.9114 -11.2099 12.673 12.9937 -533 2 9.86165 2.06107 12.2382 3.86591 -12.7401 -14.4562 -534 2 9.16654 3.26167 12.8314 9.11555 0.77907 4.27596 -535 1 2.93178 8.92582 13.081 1.70152 2.66119 1.53014 -536 2 3.14805 9.86555 12.9479 4.31652 -6.20308 -1.56758 -537 2 3.73073 8.51399 13.4597 -8.92719 0.122715 -5.32652 -538 1 3.2497 8.49808 3.73135 7.7637 26.6897 -66.399 -539 2 3.59457 9.35475 3.3251 -8.07179 -35.8245 7.88572 -540 2 3.32757 8.66083 4.63283 0.688531 4.50937 55.9505 -541 1 5.66796 7.21231 8.59238 -0.641232 -8.3741 -2.33168 -542 2 5.55885 6.25431 8.52804 10.6614 2.37054 -1.78385 -543 2 4.98671 7.4468 9.22816 0.961703 9.61661 1.51464 -544 1 14.8738 1.42122 1.93778 -12.939 -8.09002 14.9013 -545 2 14.5066 2.19936 2.41013 13.5309 -5.26917 -12.7438 -546 2 15.3961 1.64306 1.16722 2.80937 13.5796 -4.98575 -547 1 8.4154 15.1394 0.773463 -1.23857 3.93157 -9.75401 -548 2 9.15191 15.1483 1.39458 4.79594 -7.97678 6.77178 -549 2 7.72939 14.5584 1.13871 1.01453 -0.106788 3.48853 -550 1 15.5631 1.364 7.19799 20.5383 14.1474 18.9399 -551 2 14.9704 0.811359 6.72127 -20.082 -15.4085 -14.9718 -552 2 15.0111 2.04928 7.59859 -2.39038 6.78983 -5.63995 -553 1 5.04086 13.0229 18.4653 -16.526 -4.40388 -18.1368 -554 2 5.51186 13.0765 0.64315 8.46246 3.02378 17.117 -555 2 5.66208 13.3388 17.7987 -1.33855 -1.44241 4.73678 -556 1 15.3891 8.54048 18.1286 -6.10206 -9.0298 20.9903 -557 2 15.6702 9.06907 17.396 9.32842 15.5064 -17.6225 -558 2 15.3407 9.15597 0.239346 -3.25407 -2.5962 -5.00154 -559 1 12.0788 3.07289 18.3192 12.549 -10.6185 1.49283 -560 2 12.5729 2.60825 0.359083 -9.10594 9.02489 11.6275 -561 2 12.4194 2.60778 17.5512 -7.87867 2.96301 -9.52933 -562 1 13.1665 12.6793 5.14706 7.93439 -3.9476 12.1924 -563 2 13.7696 11.9755 4.86963 -4.91093 -2.83846 -5.3825 -564 2 13.2489 12.6724 6.11347 -1.2685 5.53825 -1.32442 -565 1 6.04116 7.20215 0.12064 7.04453 6.18255 -12.3628 -566 2 5.83851 8.12748 -0.154348 1.72696 -16.7644 14.2262 -567 2 5.20617 6.73813 0.252386 -0.898724 4.83199 2.26117 -568 1 17.6547 15.8889 14.9543 35.0528 -4.14946 21.8068 -569 2 16.7907 16.2722 15.0644 -14.9966 1.76464 -15.1201 -570 2 17.9353 15.7106 14.0428 -17.4402 7.26196 -6.43436 -571 1 13.1733 0.917277 16.6395 -12.3557 8.76343 2.76166 -572 2 14.0527 0.785776 16.9891 12.1183 -2.33791 -0.0845054 -573 2 12.8033 0.0287439 16.599 0.155899 -2.85039 -4.8341 -574 1 10.9713 14.5555 7.36537 -14.2255 -14.9035 9.86762 -575 2 10.1709 14.1495 7.79489 23.622 7.7433 -12.5051 -576 2 11.716 13.9517 7.54396 -5.74804 5.50666 -0.0050929 -577 1 17.5337 8.50243 2.08938 -5.40396 -31.7286 -5.54565 -578 2 16.6651 8.377 2.51924 11.1588 5.07358 -2.60802 -579 2 17.6234 7.66639 1.54889 -0.0314299 30.6214 9.39113 -580 1 12.3599 7.90174 1.98937 3.23567 -16.3128 -6.49447 -581 2 11.7961 8.65526 1.85661 -2.62113 17.411 2.96359 -582 2 12.056 7.28247 1.30894 3.22552 -0.339632 3.88847 -583 1 11.9987 14.6627 10.3756 12.942 21.9862 15.1728 -584 2 12.1481 13.8459 9.95801 9.02096 -31.6093 -18.7525 -585 2 11.0572 14.7574 10.3761 -24.4084 6.55121 -1.49817 -586 1 6.83545 6.97591 15.5496 -11.1581 -18.4558 -7.96595 -587 2 7.75433 6.91064 15.3306 20.697 -3.79434 -9.10488 -588 2 6.829 7.75126 16.0755 -7.29309 23.7102 19.2635 -589 1 8.01446 4.61093 13.3684 -42.1501 -10.3174 -21.1074 -590 2 7.18404 4.82769 12.8493 26.4504 -9.34552 12.0218 -591 2 8.34807 5.45326 13.6307 9.05324 16.4922 6.04122 -592 1 13.4266 12.1814 14.3212 -6.42777 -0.785601 -11.9683 -593 2 13.0158 11.3184 14.1828 2.17743 -6.12306 4.21948 -594 2 13.8675 12.3621 13.4761 -0.124998 4.48227 1.48561 -595 1 14.6825 9.43166 7.27492 9.85972 28.3832 27.9741 -596 2 15.5174 9.92891 7.46534 -14.0141 -13.1604 -8.13985 -597 2 14.0576 9.79435 7.94424 7.51867 -12.8522 -19.303 -598 1 12.7091 16.9592 3.18265 16.188 -54.3303 -7.24671 -599 2 12.7269 17.2341 4.07879 2.36138 14.6014 27.6129 -600 2 12.279 17.6213 2.6979 -21.2589 39.1636 -23.5451 -601 1 1.03636 7.13727 17.3765 4.75158 -4.20474 15.7377 -602 2 0.172257 7.41544 17.719 4.25282 -10.0113 -2.57097 -603 2 1.1139 7.5113 16.5007 -3.03142 8.85376 -8.54904 -604 1 12.882 5.00728 15.6915 -13.3168 2.35737 2.40623 -605 2 13.5933 4.38686 15.8029 14.6532 -13.0711 -0.480408 -606 2 13.3236 5.8608 15.7721 -0.35756 9.80313 -2.71263 -607 1 2.42233 3.36085 5.14652 -1.4819 -20.4954 -28.2661 -608 2 1.78479 3.2289 5.83557 -10.283 -5.3637 15.3955 -609 2 2.79623 4.21009 5.29825 15.429 26.5106 10.9541 -610 1 8.29403 11.1124 13.578 -10.7346 17.3121 -71.8204 -611 2 8.44225 10.8317 14.4188 2.94407 -17.9634 86.1576 -612 2 9.02074 10.6663 13.1421 6.44484 1.50589 -14.4967 -613 1 12.9406 1.47026 13.2897 0.354478 -37.8914 22.4103 -614 2 13.6523 1.40022 12.6671 11.2026 2.70228 -18.849 -615 2 12.6313 2.34545 13.2159 -11.96 35.388 -6.53093 -616 1 6.51021 13.5896 2.17003 14.8824 -7.80817 -21.2989 -617 2 5.87965 13.8406 2.83705 -10.6705 6.78718 16.3658 -618 2 7.14425 12.9838 2.58896 -6.69863 7.51381 1.45504 -619 1 15.9112 6.50963 12.6885 16.1371 8.47906 -9.98075 -620 2 16.4229 7.02402 12.0187 -10.4906 -13.771 14.0264 -621 2 16.4535 6.54884 13.5054 -11.4677 1.21509 -6.34034 -622 1 16.8027 0.705691 9.58115 1.1294 19.8318 -8.72086 -623 2 16.927 18.412 9.70296 -4.50862 -18.5326 4.35013 -624 2 16.4766 0.834017 8.66778 -1.09927 -3.21438 5.98018 -625 1 6.10776 11.6244 8.30817 -7.08025 31.3016 10.3571 -626 2 5.31117 11.3633 8.78813 -2.85933 -0.839224 -1.79107 -627 2 6.50869 10.8152 8.04097 10.2317 -24.1838 -9.43106 -628 1 2.82434 8.71866 0.367104 27.0695 8.27339 20.5452 -629 2 2.22535 8.20379 18.5266 -22.1964 -28.7808 -30.261 -630 2 2.24775 9.38106 0.731441 -2.19807 14.7641 10.188 -631 1 10.1092 10.4559 6.56308 -0.703462 -11.3062 5.02538 -632 2 10.4957 9.70218 7.03882 1.80116 3.11275 -0.176711 -633 2 10.5447 10.4553 5.70619 3.2422 0.610478 -8.25928 -634 1 6.77867 15.7679 6.62657 -1.68281 -11.8864 -9.65654 -635 2 7.19346 15.995 7.46341 4.74707 6.17504 0.549944 -636 2 7.26738 16.2069 5.90636 -4.84487 7.71134 8.89334 -637 1 6.4599 12.9833 5.69613 7.9309 12.6721 2.99822 -638 2 6.6611 13.9194 5.88765 -3.42976 -10.7335 1.27405 -639 2 6.10779 12.6203 6.51977 -0.735551 -2.83601 -1.42622 -640 1 16.7784 12.5316 9.7686 6.64513 16.9355 2.79564 -641 2 16.9553 11.9755 9.0112 -1.14761 -14.6768 -5.4217 -642 2 17.3143 13.3158 9.58219 -8.26404 -2.19889 6.01862 -643 1 6.14902 2.92407 2.76687 9.25618 8.55881 7.16487 -644 2 6.44579 3.84137 2.53376 -9.69316 -20.3131 -2.03165 -645 2 5.73381 2.47389 2.01355 1.00911 7.28801 -3.60537 -646 1 10.8507 3.14979 3.2526 -8.20022 -5.11042 -1.435 -647 2 10.2526 3.87795 3.44424 2.28516 4.24005 3.08111 -648 2 10.4324 2.67577 2.52169 3.50832 1.84172 1.62718 -ITEM: TIMESTEP -60 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.82699 6.8727 17.8888 7.11742 1.34647 0.262135 -2 2 7.99 7.13914 18.2565 -12.0864 4.19935 8.4109 -3 2 8.62901 6.07007 17.4227 -0.244169 -11.025 -10.1388 -4 1 18.7394 8.29949 6.7561 2.34576 -2.93089 -42.9257 -5 2 0.440553 7.9626 5.87052 -19.1153 18.5732 27.9896 -6 2 0.571955 7.78688 7.39134 9.59653 -12.4008 18.4821 -7 1 8.51178 18.783 6.87295 -6.05415 -5.58023 12.25 -8 2 9.39304 0.279078 6.53812 12.1519 1.3365 -4.9205 -9 2 7.9628 0.741428 6.37316 -1.87647 6.654 -3.74148 -10 1 6.53357 1.7197 11.6944 -32.7429 -8.61455 3.24653 -11 2 5.73579 2.18358 12.0739 27.4882 -10.0969 -10.5409 -12 2 6.18445 0.855878 11.3477 8.95005 26.2974 10.8481 -13 1 6.96535 5.62987 2.3961 35.6431 -32.0928 -15.0783 -14 2 6.38293 5.93218 3.05619 -24.6612 16.4463 30.6134 -15 2 6.84916 6.21974 1.66578 -5.97717 13.8881 -18.7681 -16 1 16.1974 10.2298 16.1222 0.837184 6.4903 1.28091 -17 2 17.0743 10.6189 16.0747 2.49014 -9.13099 -5.48379 -18 2 15.6463 11.0038 16.2733 -2.87215 -2.05097 1.79245 -19 1 10.6702 14.9469 2.31164 21.9083 12.0632 13.3283 -20 2 10.6818 14.2862 3.02723 -4.43621 6.7471 -1.73288 -21 2 11.263 15.6645 2.64965 -13.2726 -10.9824 -6.65814 -22 1 17.1701 8.22403 10.7142 -10.4028 1.03109 3.96163 -23 2 16.5672 8.79102 11.2349 7.05768 -1.94337 -2.70487 -24 2 17.9333 8.77716 10.499 4.44622 1.4788 -2.07857 -25 1 14.6797 15.9035 16.4693 -22.461 3.39408 -16.7947 -26 2 13.7484 16.2021 16.2951 24.3498 -9.2952 11.1 -27 2 14.6463 15.3225 17.2482 2.4047 10.3841 -3.14234 -28 1 12.1037 13.3669 0.54665 -3.27844 11.868 -6.89748 -29 2 11.8248 13.5865 18.2899 5.63772 -9.83511 -2.25753 -30 2 11.6388 14.0254 1.08354 0.310925 -7.08728 5.11983 -31 1 9.3344 5.48343 3.92748 33.8763 5.32583 -18.4372 -32 2 8.84687 5.22044 4.68611 -23.4915 -4.94858 24.7343 -33 2 8.7079 5.56619 3.20676 -14.265 -0.820383 -3.61874 -34 1 1.71101 4.06482 11.6122 14.6912 -29.1046 6.03323 -35 2 1.58258 4.96723 11.8918 -1.25551 20.6962 3.43651 -36 2 2.34968 3.65386 12.2459 -15.6865 7.58906 -11.285 -37 1 2.0576 6.82445 8.24528 12.7796 11.6573 13.2587 -38 2 2.61911 7.2356 8.94539 -14.081 -6.70064 -12.0447 -39 2 1.89349 5.9205 8.55263 1.83531 2.80349 -1.77694 -40 1 5.39864 4.45401 7.95786 1.68333 5.33174 7.59028 -41 2 5.55249 3.50745 7.87389 -3.64833 -7.88894 -5.24716 -42 2 4.83854 4.74959 7.2381 -8.525 -1.92619 -10.156 -43 1 3.30216 2.93412 17.4505 12.3495 -29.8256 -18.8762 -44 2 3.92727 3.3713 16.8479 -0.637689 -1.64749 6.41076 -45 2 2.89532 3.6118 17.959 -11.8167 26.1488 16.8317 -46 1 7.4312 5.4352 6.15055 3.3909 -0.433751 -53.1737 -47 2 7.92374 5.97877 6.73644 15.9967 14.3411 25.9486 -48 2 6.95714 4.77392 6.61797 -10.969 -14.5624 25.0012 -49 1 9.79304 6.98632 12.0044 -11.2776 3.50532 -30.3595 -50 2 10.3262 6.37648 11.4616 -6.26095 5.52929 9.55968 -51 2 9.10346 7.3395 11.3719 14.604 -9.64535 21.0978 -52 1 14.0819 3.68689 8.0984 5.37498 8.43639 24.1843 -53 2 13.9041 4.52495 7.65095 -1.63712 -2.30615 -0.914734 -54 2 14.2511 3.92795 9.04472 -1.39906 -3.736 -24.3353 -55 1 4.49163 17.2405 3.95076 10.4122 -13.5126 12.545 -56 2 5.41424 17.4498 3.85674 17.5711 4.37719 2.71306 -57 2 4.10795 17.4238 3.10711 -15.6864 12.0721 -17.6618 -58 1 16.4063 16.5742 10.3304 -30.4876 -1.09383 10.2792 -59 2 15.5552 16.587 10.8552 23.7267 -0.690427 -17.666 -60 2 16.1781 16.1401 9.48726 -2.06021 -0.342568 9.10707 -61 1 2.01216 4.81629 0.267482 -15.744 -7.33716 -25.0709 -62 2 2.32092 5.21812 1.07081 12.8803 9.20197 12.7852 -63 2 1.84588 5.54667 -0.35429 -3.07657 2.24499 6.46529 -64 1 11.4525 13.2643 16.3577 0.360612 25.402 13.2121 -65 2 11.0472 12.4174 16.5451 -7.76012 -9.6277 -2.94397 -66 2 11.9986 13.1376 15.5855 6.89063 -5.57893 -10.2697 -67 1 10.1527 10.9848 16.8633 -20.103 19.6526 2.73515 -68 2 10.5885 10.1542 16.8545 15.6291 -29.738 -2.50548 -69 2 9.22545 10.7635 16.7018 -0.592014 4.00252 0.856412 -70 1 11.7907 17.4531 13.47 6.77179 16.9038 -5.30963 -71 2 12.2429 16.8403 12.875 5.23267 3.61287 1.34276 -72 2 12.1771 18.3441 13.2664 -10.6628 -13.9509 7.62196 -73 1 6.44648 9.35189 12.2088 11.1766 16.4313 12.1054 -74 2 7.06476 9.1188 11.5034 -9.94127 -5.08631 1.40965 -75 2 6.99588 9.90362 12.7958 -7.62877 -4.94562 -4.27954 -76 1 16.2706 12.8594 2.68209 -1.75731 9.60563 4.91889 -77 2 17.1141 13.3556 2.57766 -16.4869 -7.21292 0.814827 -78 2 15.5397 13.5204 2.75856 19.4288 -8.85346 -2.79343 -79 1 0.706006 12.6575 5.91598 14.3848 1.31093 7.35726 -80 2 1.05127 12.3982 5.06653 10.4666 0.953953 -14.2919 -81 2 18.4268 12.7017 5.73438 -31.2224 -1.2993 2.30782 -82 1 5.26466 16.4058 18.4218 -16.1073 15.9927 3.08559 -83 2 5.67174 15.6665 17.9813 11.5666 -13.4602 -0.82172 -84 2 5.61268 16.4896 0.669718 7.09967 -3.66518 0.290508 -85 1 0.630514 7.71832 4.14439 -40.0144 -22.0429 16.8318 -86 2 18.6762 8.08291 3.48621 -5.56982 2.47832 -6.04635 -87 2 1.47362 7.93412 3.82987 48.6931 13.8203 -16.755 -88 1 3.15187 8.95984 6.48267 23.8542 8.38798 -14.0929 -89 2 3.71388 8.45844 7.06344 9.53544 -4.30832 6.22463 -90 2 2.31458 8.97258 6.8974 -32.9047 0.579586 11.7619 -91 1 7.26503 10.3427 16.2788 17.1997 0.0580756 -23.1821 -92 2 6.56569 10.7121 15.7432 -4.58149 2.66195 0.233626 -93 2 6.94547 10.3415 17.17 -9.40627 -4.59594 18.3856 -94 1 11.082 0.946861 5.00581 6.19269 9.74659 5.8053 -95 2 11.2852 1.82567 4.65658 -6.55006 -0.520752 -0.877191 -96 2 10.8571 0.430046 4.22808 -5.9868 -5.86677 -2.53499 -97 1 4.345 2.8292 13.2132 -1.27186 28.7368 -8.62995 -98 2 4.51529 3.21096 14.0791 1.17168 5.0352 0.572822 -99 2 4.2316 1.91147 13.3845 -6.13817 -32.6591 5.85186 -100 1 8.38376 10.2307 1.79685 4.09005 3.74222 -19.3624 -101 2 8.31491 10.9253 2.45197 -4.24337 3.92137 10.2746 -102 2 8.66929 9.45546 2.26885 2.27917 -12.8064 10.4703 -103 1 10.3305 1.70894 15.5022 6.01592 -1.55552 8.18831 -104 2 11.2875 1.57757 15.6324 -10.5356 -0.805047 -6.9053 -105 2 10.1546 1.87921 14.5629 5.4285 2.19916 1.25738 -106 1 2.65797 12.824 7.8537 2.67737 0.310449 -2.88199 -107 2 3.19441 13.4775 7.37699 -0.834696 -1.21778 5.43137 -108 2 1.94106 12.6113 7.24505 -1.36647 0.43678 -0.0339739 -109 1 3.78494 11.7026 5.05983 17.7759 13.7966 10.32 -110 2 3.63161 10.9725 5.64962 -3.29006 -9.81966 6.20688 -111 2 3.00915 11.823 4.52928 -13.3129 -0.91097 -10.8894 -112 1 6.77794 14.436 16.9596 -4.81268 9.99067 -5.99614 -113 2 7.54793 15.0018 17.1111 -0.926912 -4.93073 -4.17577 -114 2 6.38498 14.6674 16.0968 9.73202 -0.180074 3.30595 -115 1 14.2221 14.5157 3.27778 -13.9298 6.06594 9.9851 -116 2 13.8151 15.3779 3.06073 2.11094 -9.8452 8.88116 -117 2 13.8089 14.1856 4.11 4.80477 6.02161 -17.3229 -118 1 8.54544 18.1123 16.0497 -51.2002 16.193 -5.03192 -119 2 8.97127 17.2819 16.1484 30.3531 -21.0569 10.3371 -120 2 9.10378 0.243275 16.0887 21.8256 4.58901 -4.15396 -121 1 4.6724 1.65079 4.89395 -0.428695 -35.2982 26.3678 -122 2 3.9342 2.19791 5.10489 -21.2256 11.2309 2.3914 -123 2 5.17375 2.14476 4.28849 23.1392 22.1006 -30.0951 -124 1 14.9936 12.6291 16.4673 -19.77 11.4375 -24.1827 -125 2 14.4795 13.0601 17.1383 2.64859 2.32978 20.7439 -126 2 14.3496 12.6271 15.7247 18.4778 -8.83273 3.74622 -127 1 15.7172 18.4491 16.8771 -38.7365 1.31848 -37.9731 -128 2 16.4119 18.3751 17.4758 43.0193 1.36234 40.9307 -129 2 15.3332 17.5625 16.8778 1.44654 -2.1141 -5.88546 -130 1 1.31769 1.23679 16.6144 -6.54563 -5.62507 -9.64947 -131 2 2.12749 1.70533 16.7963 11.1847 9.69542 4.67012 -132 2 0.698368 1.60678 17.2434 -6.22801 1.29783 7.94738 -133 1 18.1828 4.42633 15.9571 -10.2445 4.38521 4.02875 -134 2 18.0727 3.95797 15.1342 -1.32851 -5.12675 -7.69371 -135 2 0.442412 4.30859 16.2307 9.57607 0.794437 2.0974 -136 1 12.2114 16.9885 16.1505 19.3184 14.9656 -43.0527 -137 2 11.4192 16.582 16.4369 -30.1172 -13.2398 21.5491 -138 2 12.0643 17.0779 15.1772 3.25614 1.68146 17.8786 -139 1 16.0795 2.58494 18.1555 11.3664 -10.2705 19.274 -140 2 15.8693 3.49863 18.3 -12.3112 17.2654 5.58069 -141 2 15.8977 2.41247 17.2454 -5.4363 -1.34473 -24.067 -142 1 6.67972 13.8354 10.1508 -8.25744 -4.72138 -13.3408 -143 2 6.54568 13.5231 11.0561 -0.87434 -6.75398 -1.82198 -144 2 6.44555 13.1152 9.51962 7.50297 7.52708 13.7797 -145 1 10.1393 18.4632 2.72581 -2.6903 -13.3312 7.25948 -146 2 10.3702 0.440572 2.04373 3.08075 7.1003 -10.4416 -147 2 9.34905 18.0295 2.38643 -2.95732 2.6687 3.95308 -148 1 3.05039 17.7207 6.12428 0.448774 -3.44066 -6.39261 -149 2 2.22716 17.4884 5.64326 9.1847 7.623 2.40325 -150 2 3.74061 17.8548 5.44564 -15.5509 -1.85687 4.81473 -151 1 12.5974 16.8374 7.98109 22.5462 3.91689 -18.138 -152 2 11.9813 16.1063 7.98041 -18.255 -3.99171 0.854341 -153 2 12.4106 17.4726 8.66951 -8.78709 2.06599 13.7307 -154 1 14.8906 15.2874 8.20197 12.2291 6.1037 -1.40009 -155 2 14.0169 15.6824 8.32954 6.14586 6.92547 -6.68196 -156 2 15.3058 15.6925 7.40177 -13.6896 -13.6819 15.1947 -157 1 17.774 18.2462 0.317021 16.5526 -0.292921 -8.65749 -158 2 18.517 17.6459 0.018512 -14.2865 26.6269 11.4024 -159 2 18.1212 0.514643 0.485201 -2.53379 -23.9559 -4.59837 -160 1 0.824062 10.4854 1.38532 29.0751 41.1299 -24.8426 -161 2 0.152225 9.85957 1.54468 -35.7643 -25.6114 8.77961 -162 2 0.463481 11.18 0.764874 10.1431 -20.9883 20.7352 -163 1 1.76832 12.2434 3.3342 -0.376699 -6.62105 -8.54196 -164 2 1.60728 11.5206 2.66813 -0.613387 21.7926 10.4725 -165 2 1.98383 13.0773 2.86566 -4.64348 -14.8628 -2.7215 -166 1 0.631416 17.2455 4.93339 -1.94983 -6.83399 6.66588 -167 2 18.8682 18.1422 4.98859 -2.83763 -23.6492 7.38562 -168 2 0.299607 16.5671 5.5918 8.11627 31.0276 -16.6779 -169 1 1.13057 0.905706 9.36586 -12.3827 -0.18715 22.5068 -170 2 1.31261 0.747855 10.3312 -4.25497 -2.51626 -23.3877 -171 2 0.268645 0.477115 9.21068 10.8181 5.54227 0.850191 -172 1 16.7346 2.37332 13.3038 3.72479 1.84576 21.5886 -173 2 16.9761 2.56684 12.4028 0.0757035 3.67621 -15.1405 -174 2 16.5678 1.42686 13.3713 -2.69734 -3.58003 -5.961 -175 1 2.71222 15.8556 12.0453 -23.2953 18.5694 10.7935 -176 2 3.02055 15.4773 12.8617 6.20357 -6.16654 7.20198 -177 2 3.26455 15.5565 11.3309 7.18341 -3.43964 -7.05157 -178 1 16.426 15.6488 6.1101 -14.7609 -25.4644 9.17481 -179 2 17.2826 15.6571 6.51544 16.1879 -4.44611 5.83009 -180 2 16.438 16.358 5.49538 -5.11113 23.225 -23.4349 -181 1 5.76882 5.13637 11.8122 -12.0704 17.5482 5.11471 -182 2 5.44081 5.9885 12.2003 4.95719 -19.5528 -5.70673 -183 2 5.01212 4.52871 11.8104 6.55972 2.89024 2.61392 -184 1 15.1343 4.86498 0.81249 17.6468 10.3526 -37.7608 -185 2 14.8624 4.60472 1.67155 -6.094 -8.43385 31.413 -186 2 14.42 5.38891 0.454388 -5.76674 3.16257 -0.979918 -187 1 16.354 16.4047 2.01729 -13.9507 10.6217 3.88258 -188 2 15.8491 16.8174 2.76015 19.926 -7.04016 -11.695 -189 2 16.7635 17.1307 1.5183 -3.64457 0.258913 2.52225 -190 1 0.229093 4.84171 3.85636 -16.5361 -39.1535 -9.01102 -191 2 0.280674 5.76384 3.97165 5.27146 43.6678 4.59383 -192 2 0.903367 4.46589 4.41298 10.8 -4.72049 2.86342 -193 1 2.98031 15.0696 15.1724 7.38994 17.2595 -26.1187 -194 2 2.78389 14.6733 16.0132 -4.59533 -4.91572 22.4357 -195 2 2.69496 16.0061 15.2442 -6.09825 -12.2809 0.399162 -196 1 1.14224 14.6486 9.53301 9.69931 -12.3423 3.57818 -197 2 2.08157 14.8372 9.66442 -5.69448 4.03807 -1.75917 -198 2 1.10168 13.6946 9.72739 -6.61933 10.5759 -2.74939 -199 1 13.5148 16.5367 11.5259 11.0739 -5.14125 9.92262 -200 2 13.0998 17.2443 11.0437 -3.0151 15.655 -8.61356 -201 2 13.0781 15.7617 11.1648 3.09342 -5.90037 -0.559148 -202 1 4.6468 1.4492 0.760442 21.9419 17.6404 -6.63386 -203 2 4.03376 2.00221 0.272437 -3.30289 2.18566 -6.21296 -204 2 4.11186 0.849122 1.26962 -7.6403 -10.762 3.4591 -205 1 1.46385 18.5705 11.8684 11.5971 1.37494 19.5738 -206 2 1.40443 0.572196 12.6059 -0.800227 -11.3118 -6.50307 -207 2 2.03902 17.8403 12.1929 -11.6325 11.1906 -9.16825 -208 1 11.4878 10.1514 4.00495 -23.562 -17.5625 40.225 -209 2 11.4445 10.4449 3.12053 -0.0273244 15.9845 -32.1431 -210 2 12.4087 10.0544 4.20335 22.0666 -0.101113 3.57488 -211 1 8.17978 12.1587 3.71493 28.653 -3.15285 -17.361 -212 2 9.01377 12.5671 3.97927 5.41625 0.887106 1.05136 -213 2 7.604 12.3558 4.43149 -23.5411 2.07968 29.6007 -214 1 14.5452 4.04195 3.30356 -17.0528 -5.31405 -8.64237 -215 2 15.1661 4.06926 4.02931 6.41379 4.8272 12.7333 -216 2 13.7233 4.44982 3.62226 2.87412 -0.159853 0.628569 -217 1 5.66111 1.64664 7.53337 47.3068 24.6854 -47.7691 -218 2 4.99385 1.2169 7.99076 -47.8059 -33.9417 34.4755 -219 2 5.55481 1.33937 6.59792 -2.0798 14.2024 17.8553 -220 1 17.8737 1.09537 4.84004 -13.6202 -14.1831 4.02096 -221 2 18.464 1.49436 4.20233 9.91759 7.15437 -5.32228 -222 2 17.8561 1.60546 5.65338 7.58498 6.35358 2.28946 -223 1 6.84561 9.39092 4.51119 3.77645 -4.79561 13.9854 -224 2 6.80242 9.62767 5.4641 3.30223 -6.77647 -16.668 -225 2 7.74702 9.0401 4.34673 -10.1352 5.61637 3.28246 -226 1 2.64818 14.8733 2.0031 -12.6643 -4.21043 8.13073 -227 2 3.39044 14.7832 2.61388 1.60205 1.10943 -1.58393 -228 2 2.93662 15.3311 1.21566 8.61024 -0.712779 -4.79925 -229 1 17.3356 12.9304 13.2091 0.397713 16.5012 -11.0143 -230 2 16.4513 13.2838 13.3976 5.15185 -2.46087 0.53778 -231 2 17.8465 13.7314 12.9621 -7.21788 -13.1567 2.02539 -232 1 14.9178 10.5628 1.45295 0.32879 33.5889 18.189 -233 2 15.3786 11.3985 1.79277 -12.1624 -32.8958 -12.3175 -234 2 13.9692 10.6935 1.62732 12.9477 -1.40805 -3.43718 -235 1 5.70482 6.69167 4.56094 -12.9541 28.0444 -8.31435 -236 2 5.76223 7.67071 4.46331 5.24004 -15.8993 1.97075 -237 2 6.3673 6.43877 5.21208 3.70858 -3.97365 0.601716 -238 1 7.97185 8.33683 10.3069 8.6941 -15.2025 -3.68424 -239 2 8.60404 8.92215 9.84221 -9.13329 -6.11086 -5.89913 -240 2 7.51742 7.70171 9.70626 6.59476 18.8917 -0.227694 -241 1 13.4177 18.464 5.71198 21.9916 6.6123 -14.6219 -242 2 12.6947 0.421284 5.51228 -9.11836 -2.12279 2.23123 -243 2 13.1839 18.0173 6.51737 -9.90438 -14.4062 13.6987 -244 1 0.0221035 2.62655 0.261444 12.6472 -47.1951 11.8456 -245 2 17.7527 2.75577 18.6598 -10.3686 10.7513 -7.61459 -246 2 0.546882 3.40438 0.188377 7.87852 33.0005 -3.15527 -247 1 12.8067 10.9927 9.75832 44.9647 -24.4125 8.46131 -248 2 11.8751 10.9314 9.65932 -31.4773 -7.30673 -3.09024 -249 2 13.1121 10.0761 10.034 -17.0663 24.2241 -8.13324 -250 1 0.673563 12.1459 11.0385 -14.9158 10.2345 17.3916 -251 2 18.3756 12.1565 11.2954 6.68564 0.0119082 -11.299 -252 2 1.10384 12.3853 11.8646 9.18612 4.40652 0.693569 -253 1 5.14721 7.33361 13.3929 15.7357 3.63047 1.84442 -254 2 5.59488 8.13358 13.0475 0.482915 -12.4288 -2.35902 -255 2 5.71887 7.03407 14.1269 -8.93121 6.52874 -3.37327 -256 1 1.18567 6.84505 11.8697 14.6786 34.5125 12.17 -257 2 0.393465 7.21987 11.4553 4.74321 -4.21777 2.31791 -258 2 1.70022 7.64215 12.2222 -16.972 -31.3024 -13.5319 -259 1 15.4816 9.69158 12.3277 9.90347 -39.8653 -1.57959 -260 2 15.3406 10.5924 12.1653 -13.2531 41.4735 -11.5871 -261 2 15.406 9.62533 13.2698 1.46249 -6.23285 16.1579 -262 1 16.5413 12.6347 5.5059 7.75274 -6.4804 14.118 -263 2 16.3104 13.5445 5.70094 -2.97213 12.2972 0.10227 -264 2 16.3923 12.5258 4.56955 -2.98329 -0.0504447 -18.3871 -265 1 6.30461 9.82716 0.0624729 6.72618 23.4574 16.6882 -266 2 5.51437 10.3287 0.304315 -0.069722 -0.440899 2.51054 -267 2 6.96842 10.0501 0.765687 -11.6212 -9.0506 -14.676 -268 1 12.2588 6.10042 4.03099 15.0483 24.7381 -3.94445 -269 2 12.3021 6.98896 3.58767 -5.34003 -28.327 1.95056 -270 2 11.3325 5.86569 4.06669 -11.2394 -4.89225 -2.88949 -271 1 0.336489 12.822 0.136131 -4.0328 -4.68121 -1.73262 -272 2 -0.0692718 13.3776 0.815875 4.64589 5.49593 0.971726 -273 2 18.45 12.9344 17.9884 -7.92492 5.13291 -5.47118 -274 1 3.58866 18.6351 8.62238 -6.65617 9.61834 5.79691 -275 2 3.41901 18.3768 7.70859 0.297411 -7.32139 -0.213682 -276 2 2.71275 0.31261 8.92207 15.7588 -5.16119 -5.17535 -277 1 7.50496 17.418 4.49772 -12.5742 -28.6928 8.65377 -278 2 7.55283 18.3491 4.58726 6.16277 33.1384 2.27358 -279 2 7.74423 17.2559 3.59134 -1.33953 -2.22923 -11.883 -280 1 9.26392 17.1331 12.2129 -23.7136 4.99112 -6.35848 -281 2 9.34774 16.2465 11.866 0.0093118 -9.2577 -7.50778 -282 2 9.98892 17.2487 12.8038 23.7327 3.38143 15.862 -283 1 13.3751 13.0337 7.97577 10.7478 10.6887 -13.5108 -284 2 13.3787 12.2298 8.50206 6.89696 -2.46192 7.10708 -285 2 14.2592 13.4885 8.01338 -22.4634 -9.00878 7.77512 -286 1 14.8592 2.99547 15.3735 -5.27851 1.66435 23.9116 -287 2 14.1885 2.32373 15.2402 -1.63897 -5.65445 -5.41614 -288 2 15.4149 3.00295 14.6023 9.16888 -1.78425 -15.607 -289 1 9.86925 15.6154 16.9672 4.33331 -1.89849 4.26663 -290 2 10.4152 14.8537 16.7052 -6.80597 -3.90746 -0.277805 -291 2 9.57771 15.4416 17.8827 0.419377 0.378738 -9.64067 -292 1 11.2678 8.44973 16.5939 -8.08747 -14.0791 2.0813 -293 2 10.6693 7.85604 16.0792 7.94549 12.4538 10.9378 -294 2 11.4172 8.01973 17.4598 -1.80582 0.647834 -14.6449 -295 1 3.91551 18.1683 16.8005 9.39931 12.2215 14.3903 -296 2 4.49606 17.6509 17.3756 -3.52447 -10.1131 -6.81095 -297 2 3.95318 0.38369 17.2365 -5.94998 0.470214 -7.14863 -298 1 2.19966 4.20574 8.91394 -16.952 6.25086 -28.7566 -299 2 3.11163 4.1112 8.67966 19.1354 -3.54458 -0.459765 -300 2 2.10589 3.95692 9.81579 -0.00585893 -3.49833 31.5267 -301 1 9.86514 10.3731 9.72031 15.6542 -41.5135 2.74879 -302 2 9.61489 11.2182 9.40808 -14.4527 35.546 -8.7168 -303 2 10.0569 10.3888 10.6595 -0.965326 6.48855 10.4451 -304 1 9.65603 0.92083 10.8651 15.4128 -5.93628 -1.69563 -305 2 9.35399 0.0448876 11.1808 -6.92756 10.8331 -8.061 -306 2 9.08478 1.27687 10.159 0.925367 -10.2687 5.27886 -307 1 9.17601 15.08 10.2001 28.4704 15.1584 7.58672 -308 2 8.86011 15.9493 9.94215 -4.94078 5.46469 -8.90142 -309 2 8.40516 14.5378 10.1682 -22.1716 -15.7686 -1.61012 -310 1 0.908908 9.65777 10.2661 1.02783 -39.6886 -13.0526 -311 2 0.968686 10.5462 10.5861 7.37828 17.5094 1.10535 -312 2 1.79128 9.34954 9.98968 -11.6106 9.29057 7.26807 -313 1 16.9796 4.82858 8.10785 29.2892 -10.1291 -25.9715 -314 2 16.4029 5.49318 8.42182 -23.755 22.5857 11.698 -315 2 16.8784 4.07707 8.6652 -3.89501 -13.8815 13.5617 -316 1 14.7893 14.6979 0.173135 5.39554 -7.96858 -12.7144 -317 2 15.0505 15.3823 0.785417 9.36392 5.93735 12.263 -318 2 13.9789 14.3219 0.494521 -15.109 -8.03615 11.244 -319 1 3.74323 11.0124 9.54886 4.38849 -4.14114 10.1409 -320 2 3.63158 11.395 10.4392 1.27308 -1.67175 -3.21468 -321 2 3.24423 11.5652 8.93525 -2.74645 9.31742 -2.2917 -322 1 11.2573 10.7534 1.46897 -2.74628 -20.4518 -2.00657 -323 2 11.6064 11.5358 1.05536 3.45865 20.4344 -8.16659 -324 2 10.3358 10.6724 1.18755 -1.77969 3.26872 -0.743535 -325 1 13.1779 7.19199 12.7182 14.2184 -9.05364 3.75753 -326 2 14.115 6.87295 12.7816 -17.4164 8.42328 -3.38551 -327 2 12.6212 6.40428 12.8017 3.66516 -2.90974 1.8722 -328 1 9.6094 1.86333 0.961036 -1.66559 10.1622 -20.0065 -329 2 8.74982 1.7634 0.476399 21.9169 -1.84649 8.18396 -330 2 10.2659 2.29351 0.366445 -15.6421 -6.48907 5.12748 -331 1 10.6591 13.4925 4.58018 -19.1141 -0.630091 -16.1529 -332 2 11.5305 13.1262 4.70232 12.5696 -8.82773 5.21944 -333 2 10.586 14.1761 5.24203 -0.728557 4.94256 14.6221 -334 1 14.495 1.73909 10.9749 -8.14936 -7.82556 -5.33359 -335 2 15.2253 1.30703 10.5146 2.44721 2.03735 2.44955 -336 2 14.6402 2.68373 10.8341 0.821335 1.15578 7.11863 -337 1 14.5247 12.1307 11.6327 6.29346 4.76638 51.459 -338 2 15.3146 12.4097 11.1999 18.4985 9.73575 -23.8815 -339 2 13.8662 11.9319 10.9987 -20.1843 -8.01501 -29.1382 -340 1 8.1934 5.08514 9.85848 20.6286 -7.50881 -18.2265 -341 2 7.39102 5.12991 10.3666 -14.5844 -3.05188 8.40055 -342 2 8.26178 4.1705 9.49849 -5.86813 14.6103 10.9415 -343 1 1.56363 16.9354 18.4208 -1.17306 -23.9048 5.52961 -344 2 2.13897 17.2639 17.7268 3.56106 5.06395 -9.30964 -345 2 1.54669 15.9596 18.2963 3.84009 16.9778 0.440392 -346 1 1.49268 17.3196 15.3241 -27.5122 8.95969 8.58328 -347 2 1.46041 18.2525 15.6844 -4.86102 -31.3543 -7.55486 -348 2 0.570896 16.9106 15.346 29.8648 20.9529 0.539048 -349 1 3.59911 5.78915 6.06648 9.03859 -15.9659 -5.84137 -350 2 3.1214 6.40715 6.60976 -11.746 7.94276 10.4286 -351 2 4.15987 6.31414 5.47841 1.03618 -2.86439 -0.897012 -352 1 12.5136 9.4824 14.2234 -14.5482 39.9006 11.9441 -353 2 12.9252 8.74241 13.842 20.5687 -36.5434 -22.703 -354 2 12.2915 9.17254 15.1019 -4.72781 -1.84288 9.93497 -355 1 4.05984 15.2792 6.9471 -25.1121 -18.1042 13.4141 -356 2 3.54373 16.0393 6.6659 -0.213909 7.77754 -0.115815 -357 2 4.94872 15.4739 6.70425 29.3053 8.29501 -4.075 -358 1 0.70733 8.67925 15.049 -6.53077 -6.52645 2.33041 -359 2 0.403057 9.59211 15.0995 2.0449 7.24241 -1.44461 -360 2 1.39578 8.67212 14.3782 6.73055 2.7204 -4.7895 -361 1 12.9505 8.27543 10.2426 2.52256 -9.36522 19.2887 -362 2 13.7222 7.81068 9.89429 1.56507 0.683648 -5.24915 -363 2 12.8789 7.88642 11.1491 -0.00217653 14.5673 -16.6218 -364 1 15.3477 7.80216 3.55401 -12.532 5.83489 -12.7989 -365 2 14.4906 7.48222 3.33103 -16.8871 -2.65253 -29.4538 -366 2 15.2947 7.61797 4.46883 25.5814 -3.41235 36.6493 -367 1 17.266 6.70187 0.000674068 12.1195 -8.95496 8.26487 -368 2 16.7457 6.00049 0.395257 -2.87342 -9.15243 0.336143 -369 2 16.622 7.35704 18.4101 -17.4752 15.3525 -8.08793 -370 1 8.88335 6.95399 7.81342 26.8473 24.5973 -5.8387 -371 2 9.80542 7.33522 7.87938 -25.1058 -10.3372 -2.45861 -372 2 8.7714 6.40725 8.58367 -2.11125 -14.3958 16.4377 -373 1 12.3879 0.548843 1.24082 4.42765 -0.472301 -1.45686 -374 2 13.3265 0.730859 1.40339 -2.38609 2.78881 -0.689397 -375 2 12.2563 0.636326 0.292606 2.56041 -5.4085 -0.678049 -376 1 5.63248 15.1125 14.5468 -9.48886 -16.8407 5.02155 -377 2 4.69503 15.2624 14.7723 5.83199 -5.28539 -1.87026 -378 2 5.99589 15.9615 14.314 8.44734 16.7096 -6.42729 -379 1 3.85575 6.39433 1.75493 1.50274 -8.79363 8.51258 -380 2 3.48975 7.20754 1.41538 -8.87879 17.021 -2.96274 -381 2 4.03803 6.55873 2.69128 -1.36395 1.28851 -4.88856 -382 1 3.93631 11.5299 12.3893 -8.10483 -0.317118 -5.66906 -383 2 4.80663 11.9435 12.4577 -3.51298 -1.2689 0.972005 -384 2 3.32279 12.1457 12.8171 1.30391 -5.08042 -1.13556 -385 1 5.30379 3.85961 15.861 3.26535 -66.7729 -21.4105 -386 2 5.99128 3.21668 15.5051 -18.0074 17.9789 14.3955 -387 2 5.71814 4.68422 15.8683 22.7973 48.3912 1.26107 -388 1 14.279 10.1761 4.52146 -28.2637 29.6843 37.5781 -389 2 14.4726 9.82647 5.40905 -2.50301 -0.0307068 -4.88302 -390 2 14.7482 9.65242 3.92054 26.3189 -27.9191 -30.9088 -391 1 7.73542 17.3919 9.15036 20.9187 -26.1564 3.32362 -392 2 6.89787 17.6412 9.51878 -14.391 11.6651 3.78997 -393 2 7.98556 17.9488 8.40931 -4.18052 11.5531 -5.69175 -394 1 4.50439 14.5239 3.99264 11.0977 -23.3764 -48.4991 -395 2 4.56306 15.4325 4.20277 -1.38797 35.5351 15.6514 -396 2 4.31322 14.0314 4.76491 -6.35847 -16.1784 30.998 -397 1 14.1606 7.45193 15.811 -24.1382 -9.56247 -10.586 -398 2 15.0553 7.36431 15.524 24.9604 -3.00047 -8.7167 -399 2 14.2305 7.91189 16.6334 1.28104 8.01927 19.5585 -400 1 2.99693 18.3516 1.90386 -17.8633 -43.3253 -26.4279 -401 2 2.47403 17.7132 1.31624 19.6124 26.5697 18.0429 -402 2 2.33007 0.205152 2.36966 -11.145 11.7012 10.1025 -403 1 8.00896 1.59538 4.54643 -14.6935 -3.1209 6.18761 -404 2 7.42733 1.99671 3.8763 8.34922 -0.442348 -1.34208 -405 2 8.90764 1.54031 4.21745 2.64121 3.0498 -7.75206 -406 1 2.41984 14.15 17.6911 38.7391 17.8224 -8.42313 -407 2 1.65201 13.6768 17.9262 -26.9962 -21.4224 14.4939 -408 2 3.15619 13.6354 18.0755 -0.305296 5.75785 -2.4818 -409 1 0.881322 1.80893 13.8899 -12.9164 4.63859 7.1799 -410 2 0.998981 1.67187 14.8549 -5.47541 -0.367675 -15.7697 -411 2 18.568 1.96442 13.7158 18.7475 -1.65173 8.16576 -412 1 4.35626 0.108756 13.8915 -10.9503 4.16473 7.68997 -413 2 5.20313 18.36 13.6952 15.0207 -4.30703 2.98167 -414 2 4.18562 18.5651 14.8318 -0.53115 -1.77986 -5.89667 -415 1 7.21985 0.783193 18.3638 -3.94277 -6.88163 -25.1551 -416 2 7.12969 0.383485 17.4575 9.77138 9.98351 24.3944 -417 2 6.41237 1.28912 18.5059 -6.03182 -4.67978 5.08395 -418 1 15.9996 18.4041 13.9383 18.1315 -1.4443 -10.5581 -419 2 15.071 18.4425 13.7445 -14.3326 2.53282 3.85714 -420 2 16.1651 18.6473 14.8506 -8.9044 -3.87569 12.2679 -421 1 10.1939 4.54115 16.2821 35.3159 -4.68875 2.87762 -422 2 11.1919 4.40884 16.3129 -34.2522 14.5881 -3.55905 -423 2 9.86192 3.67371 16.0442 -3.43039 -7.24249 -0.81883 -424 1 15.9323 17.7355 4.44233 22.6638 -20.6434 -12.8847 -425 2 16.5412 -0.18272 4.5755 6.4476 10.7336 -1.45992 -426 2 15.0915 18.0468 4.70328 -34.4096 13.9436 14.4512 -427 1 6.99117 17.4686 13.8836 -42.0334 -7.7574 -17.1448 -428 2 7.47631 17.7428 14.6303 20.6357 14.1189 34.523 -429 2 7.65356 17.3815 13.215 15.8945 -3.28854 -19.4769 -430 1 13.2291 6.49408 6.5607 17.0277 2.09005 0.593761 -431 2 14.1816 6.76782 6.52286 -25.3304 -6.60509 -4.73803 -432 2 12.9166 6.35235 5.64754 5.89534 0.461784 7.57918 -433 1 7.85324 2.32148 9.35275 5.46391 6.9162 26.9577 -434 2 7.3686 2.17076 10.1976 2.69269 5.61176 -14.2633 -435 2 7.26481 2.08775 8.6472 -14.0957 -9.57593 -14.6111 -436 1 15.2023 14.7793 13.7187 7.74208 -16.2001 -4.59991 -437 2 14.8319 14.9596 14.5759 -4.08925 6.59301 14.3355 -438 2 15.0747 15.5488 13.1771 -7.6118 10.0658 -7.58078 -439 1 9.41047 8.32341 3.83123 -6.47708 13.1987 -5.34522 -440 2 10.2452 8.80483 3.85219 3.73168 3.01968 4.76716 -441 2 9.63137 7.40393 3.95808 -1.29777 -11.5098 0.542939 -442 1 17.7649 13.5922 16.3898 -11.4367 -25.6902 16.7919 -443 2 16.7908 13.5407 16.3666 6.32242 -2.67761 -0.626712 -444 2 17.9873 14.3645 15.8914 0.275374 22.0623 -11.5119 -445 1 4.92213 10.5724 2.8597 -4.83644 2.51404 -15.3254 -446 2 5.59736 10.2151 3.4378 8.5726 -2.027 3.49443 -447 2 4.66951 11.4171 3.23999 1.02108 -1.77966 3.70944 -448 1 3.74742 8.38157 10.0278 -2.2319 9.94706 -11.0912 -449 2 3.89489 9.30484 9.7273 -4.74563 -10.9217 8.16333 -450 2 3.84233 8.40088 10.9831 -0.997449 0.744123 6.62097 -451 1 15.9666 6.96875 6.01253 -14.8276 15.8227 3.08109 -452 2 16.7817 7.37259 6.30064 12.9112 7.94175 5.43996 -453 2 16.2196 6.12219 5.66656 5.41287 -21.5059 -0.527712 -454 1 15.1391 7.15478 9.02923 3.95319 -30.3017 38.192 -455 2 15.9165 7.52141 9.44882 9.73374 3.98045 10.059 -456 2 15.0698 7.60427 8.22918 -5.81948 28.1077 -46.3627 -457 1 6.22822 12.9188 12.7298 1.31868 -8.19268 -13.1839 -458 2 6.88351 12.2656 13.01 8.10485 3.82836 6.8834 -459 2 6.11855 13.5785 13.4162 1.19396 9.04898 12.3458 -460 1 12.1253 4.52441 13.1066 -23.5121 -14.293 -11.093 -461 2 12.4631 4.60406 14.0095 -9.44452 -2.69015 3.06865 -462 2 11.2831 3.97256 13.0795 31.8956 18.265 6.80246 -463 1 11.4055 8.12657 7.94639 -16.7563 2.96014 -17.3287 -464 2 11.9383 7.50834 7.43372 10.7385 -1.00284 -0.366803 -465 2 11.8652 8.24712 8.77366 5.83315 -1.26494 14.2429 -466 1 17.1037 10.8819 7.56719 -22.1575 4.54299 3.0458 -467 2 17.7705 10.2842 7.28531 25.0286 -24.4015 -2.83309 -468 2 16.8908 11.3655 6.76798 -3.05919 12.9941 -4.73253 -469 1 5.25302 18.1256 10.9232 26.818 -0.191878 -4.18594 -470 2 4.8269 17.8089 11.6994 -14.1597 -10.1429 18.6642 -471 2 4.64144 17.9747 10.2197 -19.8227 3.49229 -23.3423 -472 1 7.59833 17.4619 1.74995 8.37542 2.1771 -36.4257 -473 2 8.02215 16.748 1.21035 -16.0406 12.4022 13.5887 -474 2 7.374 18.1677 1.08602 7.01745 -13.9463 17.8331 -475 1 1.92633 12.907 13.6044 0.0880561 -5.46821 -16.7511 -476 2 1.47807 12.3822 14.2652 -4.39349 -7.86198 7.054 -477 2 2.32754 13.632 14.072 3.07665 17.0427 10.8635 -478 1 9.50987 6.80039 14.836 2.18935 -20.8269 12.8739 -479 2 9.79082 5.96037 15.3114 -4.54962 20.4196 -21.9392 -480 2 9.66995 6.7436 13.8735 6.47407 0.337666 8.03802 -481 1 15.2827 4.32341 10.7768 10.307 9.68599 -4.89646 -482 2 16.2397 4.0919 10.6916 -21.0983 9.39835 9.69703 -483 2 15.2266 5.10894 11.3663 5.46907 -15.4805 -5.79884 -484 1 11.3016 6.20596 0.140794 12.6043 6.09542 0.747046 -485 2 11.4786 5.29078 18.6344 12.8703 -22.3778 -2.75052 -486 2 10.381 6.25156 -0.0726873 -21.1699 14.4442 -0.985902 -487 1 -0.0715916 11.4097 14.9721 22.1692 -7.15633 35.3796 -488 2 18.1992 11.7732 14.1947 -21.0416 8.6568 -29.4322 -489 2 -0.201181 12.1402 15.5966 -0.594523 -4.50066 0.166015 -490 1 7.04588 9.27411 7.30476 9.145 16.929 -11.701 -491 2 6.64583 8.45304 7.57308 -6.76023 -15.305 10.0219 -492 2 7.98749 9.10222 7.20319 2.10913 -2.81405 2.65036 -493 1 18.3255 15.3308 12.2943 -10.9271 3.22482 1.76971 -494 2 0.551901 15.6023 12.004 16.2571 0.370549 -2.10144 -495 2 17.7334 15.6802 11.6169 -1.97195 2.58378 -3.71708 -496 1 16.5011 4.39937 5.27673 4.48444 11.2976 -56.5136 -497 2 16.7777 3.84422 5.96849 7.0389 -19.8316 37.8082 -498 2 17.2036 4.29545 4.59204 -6.79319 11.0559 14.2779 -499 1 17.7009 3.16012 10.7623 -11.0785 -13.2259 -8.21854 -500 2 -0.0365931 3.41438 10.9472 14.4195 -1.11458 2.04579 -501 2 17.6933 2.32175 10.2562 4.60522 6.17753 6.57508 -502 1 12.2846 -0.0106908 10.1146 7.09195 -37.1879 -10.2172 -503 2 11.3926 0.256016 10.2673 -25.9358 14.4274 7.98014 -504 2 12.8288 0.732071 10.298 19.2326 28.445 5.65892 -505 1 10.3866 9.75519 12.5017 -6.95633 -10.4248 -20.8372 -506 2 11.1983 9.82383 13.0055 7.4239 -2.70171 9.41801 -507 2 10.3064 8.80301 12.2683 1.05955 14.1529 10.144 -508 1 0.648708 2.774 7.07027 -1.36725 -4.55963 12.8723 -509 2 0.490272 3.61188 7.51443 -2.95105 4.17746 -2.75047 -510 2 1.10621 2.25999 7.75495 -4.79333 -3.92365 -3.87978 -511 1 0.307244 15.292 6.87913 -0.83379 49.2439 44.5727 -512 2 0.652444 15.3347 7.80405 -9.58611 -2.1659 -14.8737 -513 2 0.567348 14.4512 6.61032 15.5663 -52.8882 -22.8213 -514 1 17.056 6.99125 15.1184 -7.99596 0.858836 -4.56633 -515 2 17.7814 7.62276 14.9808 0.742784 -5.19204 3.90514 -516 2 17.4035 6.24942 15.6288 5.94943 -0.679765 0.413052 -517 1 9.13726 12.4999 8.01885 37.0353 0.885775 16.8739 -518 2 9.52568 11.8572 7.39973 -10.6447 2.68521 -0.695331 -519 2 8.21726 12.5875 7.87097 -30.0746 -3.81245 -10.8301 -520 1 1.21553 1.74407 2.88052 -2.59699 -2.39415 1.38589 -521 2 0.835324 2.14494 2.08419 1.70776 2.79001 2.24225 -522 2 1.71989 2.41102 3.3678 0.071784 1.92406 -2.09937 -523 1 4.07628 15.1457 9.88397 17.4433 -7.82557 -1.54586 -524 2 4.111 15.2412 8.92029 0.253189 0.655179 -3.36934 -525 2 4.94389 14.7737 10.148 -8.68797 4.30724 -10.2942 -526 1 7.35101 2.21809 14.6867 -7.35168 5.20952 -5.71558 -527 2 7.12719 1.57839 13.9999 0.606569 0.313122 2.88765 -528 2 7.62455 3.00796 14.1978 2.82745 -2.40467 5.3071 -529 1 18.457 14.6023 2.16488 -22.5257 23.4253 1.52633 -530 2 0.650438 15.0238 2.37846 9.31401 -4.06208 0.652559 -531 2 17.8015 15.3468 2.21006 9.59865 -20.266 -2.54542 -532 1 9.9778 2.69966 12.9163 0.655502 16.6224 11.2027 -533 2 9.96654 2.13525 12.1425 -5.01566 -7.38072 -9.38582 -534 2 9.27217 3.36428 12.8011 2.98946 -10.098 -0.342741 -535 1 2.95791 8.92102 13.0894 10.3197 8.62466 2.37945 -536 2 3.25022 9.8484 12.9226 -2.55555 -16.3803 0.657875 -537 2 3.7553 8.44758 13.4136 -17.8894 4.38499 -5.11642 -538 1 3.26012 8.5452 3.75851 7.68136 4.64814 -61.3797 -539 2 3.65213 9.34274 3.2957 -8.84339 -23.8918 18.3111 -540 2 3.19772 8.72964 4.66662 3.169 13.2307 40.2657 -541 1 5.70723 7.22602 8.61089 15.0471 5.15238 -9.7988 -542 2 5.61347 6.27934 8.4361 -3.3163 0.301479 7.52532 -543 2 4.97449 7.5436 9.15453 0.52499 -8.4302 1.10573 -544 1 14.8706 1.4621 1.8863 1.70998 27.5213 20.9307 -545 2 14.7201 2.23316 2.46749 -8.28585 -15.753 -0.675778 -546 2 15.5631 1.82311 1.33978 3.90729 -10.8233 -20.0391 -547 1 8.4891 15.095 0.746196 -1.67248 3.44686 2.60315 -548 2 9.16152 15.1411 1.43932 5.44244 -6.16758 -2.29782 -549 2 7.78914 14.5375 1.12422 -1.25934 1.00196 -2.01266 -550 1 15.531 1.37665 7.20033 20.0832 14.6351 13.3031 -551 2 14.8916 0.843079 6.76136 -18.4007 -14.9103 -14.8508 -552 2 15.066 2.19014 7.43626 -3.82192 3.26637 1.54172 -553 1 5.03616 12.9919 18.445 -16.5564 -3.92778 -1.34985 -554 2 5.49952 13.0651 0.633359 3.65082 -0.909975 11.8673 -555 2 5.58799 13.4788 17.838 5.35286 -1.67587 -4.32886 -556 1 15.4004 8.57696 18.1096 -13.5133 -17.3986 23.7812 -557 2 15.6963 9.177 17.4428 12.1428 17.8023 -17.443 -558 2 15.2132 9.11981 0.25138 2.83515 1.87454 -5.46736 -559 1 12.0742 3.0873 18.3015 -13.0771 12.9456 1.32203 -560 2 12.4416 2.71193 0.467697 5.19488 -4.15516 -6.31478 -561 2 12.3414 2.59119 17.5164 7.34103 -8.20972 9.84797 -562 1 13.1603 12.6784 5.14975 4.6094 5.88635 0.276196 -563 2 13.6665 11.971 4.72065 -1.49243 -3.38503 8.68718 -564 2 13.2851 12.6103 6.1136 1.29016 -0.295852 -5.09341 -565 1 6.06548 7.22062 0.130395 -10.0215 14.1887 -9.78073 -566 2 5.90478 8.1622 -0.126677 10.3505 -23.4507 13.8616 -567 2 5.20282 6.91875 0.452817 7.86884 -4.47391 0.318594 -568 1 17.6551 15.8705 14.9463 -5.31761 6.83655 -25.2986 -569 2 16.721 16.066 14.8837 -6.35164 3.20497 21.4179 -570 2 17.8286 15.8261 13.9944 18.3936 -6.902 3.79502 -571 1 13.1598 0.895115 16.6829 -10.2787 13.0231 -1.21317 -572 2 14.0985 0.838925 16.8484 11.7714 -2.60716 3.82434 -573 2 12.9094 -0.0108285 16.49 -7.09766 -5.67505 2.02872 -574 1 10.9245 14.5193 7.39494 -10.4099 -10.8827 23.6465 -575 2 10.1209 14.2503 7.91799 23.546 5.98273 -19.3945 -576 2 11.6246 13.8906 7.65805 -5.45953 8.29317 -8.96944 -577 1 17.5666 8.45977 2.1077 -2.45541 -18.4017 -7.84499 -578 2 16.6916 8.4078 2.54921 14.2221 -0.924117 -8.74119 -579 2 17.6058 7.68446 1.4828 -2.53767 24.5137 15.8214 -580 1 12.3693 7.85876 1.99742 11.9287 1.39128 11.652 -581 2 11.9574 8.70597 1.81668 -2.84663 4.1279 -5.57453 -582 2 12.0661 7.22941 1.33154 -5.87406 3.00715 -1.1515 -583 1 12.0244 14.6632 10.3909 28.0505 -1.98221 6.53788 -584 2 12.2154 13.9026 9.84664 0.841551 -5.23881 -6.52272 -585 2 11.0973 14.8027 10.3697 -37.2752 0.615569 -5.61626 -586 1 6.83101 6.95959 15.54 -26.922 -25.3261 -7.84618 -587 2 7.74646 6.93869 15.3131 28.0025 5.72032 -4.23149 -588 2 6.70706 7.70294 16.1074 0.47288 18.1258 13.2198 -589 1 7.99181 4.56873 13.323 -17.7662 10.8645 -2.94772 -590 2 7.11502 4.75523 12.8947 23.3848 -2.11675 2.9311 -591 2 8.34221 5.42155 13.6369 -8.03699 -10.5621 -3.57795 -592 1 13.4097 12.1854 14.3195 -5.65215 6.28756 1.83858 -593 2 13.0403 11.2921 14.2436 5.24433 -3.00833 -1.58816 -594 2 13.8498 12.3732 13.4771 -2.55607 -2.02901 -2.35573 -595 1 14.6454 9.43305 7.28195 10.7596 15.6461 6.41649 -596 2 15.5174 9.89596 7.36949 -20.7431 -7.51972 6.68313 -597 2 14.0059 9.84843 7.89782 12.5114 -5.65293 -10.9965 -598 1 12.693 16.9181 3.21868 4.13721 -47.3842 -7.97708 -599 2 12.7878 17.338 4.04875 4.47204 15.8163 32.4195 -600 2 12.4838 17.5994 2.61833 -10.0532 31.8516 -27.8744 -601 1 1.00841 7.13021 17.3596 12.9632 -6.47488 11.204 -602 2 0.140567 7.22584 17.7618 -2.41623 -7.13214 2.78808 -603 2 0.956632 7.61621 16.5408 -0.0488819 7.87685 -11.8994 -604 1 12.917 4.94058 15.6965 -33.9833 6.00302 -1.61153 -605 2 13.6432 4.4005 15.9475 28.608 -13.7192 2.54357 -606 2 13.1955 5.85458 15.7909 9.71851 9.87704 0.635703 -607 1 2.3887 3.3689 5.15584 14.955 -15.9692 -52.0278 -608 2 1.80093 3.08916 5.81858 -25.593 -10.9876 33.4797 -609 2 2.79381 4.15677 5.46164 14.8077 31.4017 13.6729 -610 1 8.27435 11.0395 13.6153 -37.0795 23.6732 -65.6931 -611 2 8.36475 10.9269 14.5167 14.9976 -12.7369 63.1872 -612 2 9.08207 10.7919 13.1709 13.5323 -11.5041 2.55762 -613 1 12.9711 1.50053 13.2758 -7.16838 -21.0368 21.1096 -614 2 13.525 1.50324 12.5105 16.6349 2.94139 -20.1138 -615 2 12.6114 2.3778 13.3258 -6.20414 13.0805 -2.33086 -616 1 6.55993 13.5741 2.17335 4.5265 3.63418 -23.4358 -617 2 5.93511 13.8533 2.83279 -12.7543 7.85744 13.7798 -618 2 7.20659 13.0527 2.65116 1.25385 -4.10852 0.808212 -619 1 15.8831 6.47501 12.6409 22.0814 4.72601 -0.603906 -620 2 16.4738 6.98335 12.028 -14.2245 -11.2946 14.6347 -621 2 16.3705 6.43226 13.5009 -10.5632 5.96191 -15.5708 -622 1 16.8031 0.705923 9.56407 -2.28595 11.5891 -8.26827 -623 2 16.6552 18.4511 9.84906 2.3526 -17.7501 5.98934 -624 2 16.3731 0.773302 8.69375 1.62838 3.03603 0.698224 -625 1 6.10625 11.6157 8.28914 -3.08711 55.9701 7.34602 -626 2 5.36711 11.2964 8.79127 -16.3164 -7.54559 6.80515 -627 2 6.5283 10.8686 7.94164 19.8706 -42.6353 -12.8098 -628 1 2.81358 8.70539 0.376179 36.8039 -5.08598 16.3747 -629 2 2.33554 8.23944 18.3571 -22.6922 -9.90678 -17.9478 -630 2 2.28148 9.42572 0.700092 -14.5476 7.98537 3.82577 -631 1 10.114 10.4289 6.56839 -5.48816 -6.21666 7.2072 -632 2 10.5648 9.70982 7.03635 1.99723 -0.0329781 -1.13968 -633 2 10.3487 10.347 5.64237 7.8387 0.67993 -6.97128 -634 1 6.81211 15.7679 6.65103 -0.348958 5.58939 -1.23617 -635 2 7.12762 16.1335 7.48534 -0.336507 -3.46393 3.99871 -636 2 7.12562 16.4168 5.9986 -1.75978 -6.48118 -4.29666 -637 1 6.49059 12.9347 5.74014 0.722488 11.3509 6.39713 -638 2 6.52544 13.8593 6.05125 4.61742 -7.45139 -3.43251 -639 2 6.13117 12.4341 6.48422 -0.637044 1.07223 -0.836688 -640 1 16.7722 12.5296 9.75372 -10.3378 8.80589 22.9139 -641 2 16.9709 11.8837 9.07779 5.41942 -3.21474 -11.15 -642 2 17.3199 13.309 9.62307 0.866334 -2.28521 -6.10033 -643 1 6.18734 2.89369 2.76381 6.70118 21.5641 -20.0406 -644 2 6.53969 3.77128 2.46465 -8.05809 -16.0544 14.4298 -645 2 5.6766 2.59589 1.99155 1.09601 -8.68373 7.94101 -646 1 10.8178 3.09588 3.24672 1.33393 -8.05069 0.148042 -647 2 10.2056 3.80475 3.46561 0.323029 3.07521 -1.63087 -648 2 10.3998 2.55919 2.55618 -0.935454 8.00813 2.52947 -ITEM: TIMESTEP -70 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.83052 6.78564 17.8747 4.81039 14.7119 7.93216 -2 2 8.02044 7.08583 18.306 -2.95347 -6.04078 -1.17349 -3 2 8.57794 6.09723 17.2713 -4.49598 -11.7014 -7.63976 -4 1 0.124161 8.31212 6.74558 -2.09679 -1.27724 -21.4903 -5 2 0.320991 8.02726 5.80661 -3.30063 7.0305 29.7013 -6 2 0.593986 7.72695 7.35611 1.84479 -1.64007 -4.64643 -7 1 8.55341 0.214487 6.89794 4.20955 -4.60902 11.3327 -8 2 9.45965 0.255338 6.58274 3.95615 -0.229119 -0.443755 -9 2 8.09377 0.850204 6.35793 -6.3823 8.35705 -5.64785 -10 1 6.52177 1.69631 11.7106 -29.0447 -4.52087 -3.66773 -11 2 5.85029 2.25877 12.1616 13.2184 -10.2105 -7.98022 -12 2 6.00884 0.936302 11.3174 15.6542 21.0994 14.986 -13 1 6.92822 5.5902 2.37948 23.4336 -17.8876 -5.1013 -14 2 6.5261 5.8779 3.18071 -18.514 8.45901 19.042 -15 2 6.74676 6.28055 1.75003 -1.36947 6.04298 -15.8103 -16 1 16.1916 10.2374 16.1412 -24.0328 -6.0953 4.14694 -17 2 17.0138 10.497 15.7581 19.6671 8.99174 -7.62884 -18 2 15.6617 11.0456 16.2513 11.6446 -5.87426 0.419849 -19 1 10.7179 14.9528 2.30402 9.26606 5.76352 20.4147 -20 2 10.604 14.349 3.06349 2.85769 5.88214 -5.84145 -21 2 11.1755 15.7297 2.69585 -5.79349 -8.7688 -7.8832 -22 1 17.1683 8.21322 10.7989 1.82063 -1.23871 -1.95171 -23 2 16.5117 8.80699 11.1832 -0.385781 3.51193 7.00123 -24 2 17.9642 8.75858 10.6912 0.976865 0.382705 -5.65698 -25 1 14.6466 15.9322 16.4418 -21.6809 -6.01765 9.50279 -26 2 13.7097 16.2329 16.4085 18.6708 -4.64396 -3.84163 -27 2 14.6751 15.3815 17.2568 4.92661 10.5457 -14.6576 -28 1 12.1005 13.348 0.567693 14.0677 -11.0124 3.49805 -29 2 11.7977 13.4785 18.3054 -3.25303 6.53047 -2.60123 -30 2 11.7369 14.0166 1.16546 -7.92056 -0.136763 -7.41856 -31 1 9.34615 5.48792 3.88275 21.7787 0.248377 2.40385 -32 2 8.84331 5.37966 4.67443 -9.14 -4.08483 27.4632 -33 2 8.65688 5.52523 3.23949 -14.702 1.76912 -26.3373 -34 1 1.6606 4.00652 11.6035 4.04251 -10.384 -6.17332 -35 2 1.67583 4.94617 11.8049 -2.44143 11.0832 5.72027 -36 2 2.2695 3.55993 12.2146 -3.92557 1.72629 -0.38872 -37 1 2.08139 6.85853 8.20375 5.25116 9.81515 7.60897 -38 2 2.56831 7.24635 8.96213 -7.90159 -5.93168 -10.5698 -39 2 2.00199 5.91426 8.39105 -0.650687 0.0621593 5.33933 -40 1 5.36768 4.45674 7.91405 -3.32795 5.87339 3.17518 -41 2 5.46396 3.51228 8.0104 5.66802 -14.4695 -1.12836 -42 2 4.78412 4.56623 7.16078 -4.98903 9.02084 -4.56071 -43 1 3.31193 2.91026 17.4243 5.25503 -22.5991 -0.535021 -44 2 3.97925 3.43469 16.9765 8.2555 0.833912 -8.18173 -45 2 2.82292 3.51814 17.9594 -9.74498 21.4045 11.9966 -46 1 7.44628 5.47686 6.16962 4.83779 4.18627 -38.8589 -47 2 7.80337 6.02378 6.84422 19.7966 19.2933 17.1246 -48 2 7.08839 4.74785 6.63594 -15.5951 -22.4752 14.0992 -49 1 9.79841 6.99298 12.0115 -14.4173 0.175621 -19.7413 -50 2 10.2338 6.25953 11.5352 -7.27244 10.6531 4.67439 -51 2 9.07403 7.33711 11.4082 20.5779 -11.7539 16.8314 -52 1 14.0932 3.73018 8.11294 -2.35225 21.206 2.79521 -53 2 13.7164 4.53948 7.70027 6.06412 -15.1972 7.35067 -54 2 14.2932 3.96864 9.04107 -1.96145 -2.4542 -11.4015 -55 1 4.4865 17.2305 3.91995 2.87421 -17.2964 21.8602 -56 2 5.37817 17.5632 3.85852 13.1015 6.2627 -4.15101 -57 2 4.01126 17.4425 3.12603 -6.70645 13.3364 -16.7923 -58 1 16.3503 16.556 10.4027 -28.8153 -10.9362 -6.11544 -59 2 15.5262 16.5238 10.94 14.5825 4.08322 -8.19499 -60 2 16.0782 16.1167 9.56389 6.69544 5.4961 14.7824 -61 1 2.00781 4.81695 0.19428 -16.7794 -3.94444 -13.379 -62 2 2.36068 5.21925 0.976813 15.1603 4.4174 16.1734 -63 2 1.77343 5.5764 18.2905 0.379182 1.41768 -5.2961 -64 1 11.3582 13.2716 16.3898 -3.93488 16.8957 9.12151 -65 2 10.9039 12.4355 16.5285 -2.10099 -6.82713 -1.65452 -66 2 11.9323 13.1324 15.638 7.04428 -4.38588 -8.74921 -67 1 10.1365 10.938 16.8467 -2.82235 24.3376 4.32555 -68 2 10.5718 10.0987 16.7812 6.05632 -17.4389 0.305733 -69 2 9.20542 10.7786 16.7086 -10.6888 -4.42603 -1.21793 -70 1 11.8139 17.4685 13.4625 16.8497 6.47801 1.45884 -71 2 12.3399 16.8066 12.9857 -2.09189 7.12722 0.625626 -72 2 12.305 18.316 13.3535 -13.8327 -6.90215 0.736174 -73 1 6.44924 9.38958 12.2401 6.69888 0.367183 -15.9058 -74 2 7.02028 9.14259 11.4734 -10.412 6.11649 20.9521 -75 2 7.00474 9.9221 12.8226 3.16796 0.0903621 -0.913647 -76 1 16.2861 12.8631 2.69282 -5.5095 27.1919 6.93721 -77 2 17.1297 13.3403 2.5399 -11.4064 -12.6315 1.20497 -78 2 15.6248 13.5969 2.82884 15.7371 -22.5818 -6.03687 -79 1 0.705842 12.6958 5.89372 11.1118 0.602373 24.8353 -80 2 1.18521 12.4959 5.09265 -4.47491 1.87676 -19.0631 -81 2 18.418 12.5564 5.72922 -11.8137 -1.703 -8.70405 -82 1 5.28198 16.3804 18.4185 -2.246 1.3069 9.83982 -83 2 5.62966 15.5825 18.0261 2.19299 -6.30074 -9.03385 -84 2 5.78103 16.4802 0.590407 -0.738213 6.24336 1.72583 -85 1 0.669378 7.71651 4.13384 -59.2278 -40.1014 26.2385 -86 2 0.0696389 8.03317 3.4616 -5.2936 5.59306 -12.1338 -87 2 1.48105 8.07531 3.93226 66.8664 27.2164 -22.0097 -88 1 3.17848 8.98449 6.48797 -11.6429 31.0556 -28.5774 -89 2 3.69754 8.52221 7.10624 17.5545 -20.4274 28.0681 -90 2 2.28321 9.06095 6.81713 -8.12873 -6.01142 5.66961 -91 1 7.27057 10.3561 16.259 12.8547 -0.986094 -7.05958 -92 2 6.52139 10.8488 15.9387 -6.88577 4.52419 -2.25862 -93 2 7.07809 10.1849 17.1799 -5.89204 -3.21212 7.89434 -94 1 11.0493 0.926342 5.00492 7.6282 -0.312775 10.2028 -95 2 11.2745 1.78939 4.63491 -8.49938 0.0964505 -4.50291 -96 2 10.791 0.378052 4.25157 -0.730025 2.38059 -0.222793 -97 1 4.31171 2.85627 13.1955 -2.92819 26.6809 -11.7177 -98 2 4.37585 3.38692 13.9969 4.42074 -3.40265 4.05123 -99 2 4.21422 1.95476 13.4751 -3.58996 -22.8444 6.9477 -100 1 8.4068 10.257 1.78795 4.04191 -13.9705 -5.37842 -101 2 8.26785 10.8775 2.49552 -4.14797 15.7472 11.4003 -102 2 8.5529 9.42866 2.25521 3.43453 -4.46737 -1.06154 -103 1 10.2803 1.70096 15.4762 8.76071 -4.61575 -1.32446 -104 2 11.1657 1.41822 15.7142 3.10462 2.167 2.36838 -105 2 10.3075 1.82832 14.5156 -8.33356 3.27592 2.91474 -106 1 2.63173 12.8085 7.89063 4.0959 -9.21484 -0.859497 -107 2 3.2295 13.3973 7.41028 -2.49756 4.22571 1.84267 -108 2 1.98308 12.5062 7.24287 -1.99659 4.67741 -0.497136 -109 1 3.82895 11.7184 5.01628 -2.65331 8.28036 11.6201 -110 2 3.66291 11.1157 5.74556 0.426771 -3.98214 -1.1075 -111 2 3.01542 11.7805 4.50368 -0.128738 -0.0731644 -2.81963 -112 1 6.76514 14.4734 16.965 3.61018 3.02569 -11.8589 -113 2 7.44445 15.1431 17.0872 4.2046 -3.50831 2.36163 -114 2 6.5725 14.4959 16.0119 -5.95898 4.08629 6.49151 -115 1 14.2172 14.5156 3.23512 -15.7654 4.80027 20.0484 -116 2 13.9157 15.4376 3.23841 -0.320177 -6.15912 -4.56224 -117 2 13.7912 14.1249 4.0321 9.04818 0.126488 -15.8424 -118 1 8.62194 18.1001 16.0659 -23.21 2.71751 -2.03066 -119 2 9.16623 17.3958 16.3546 8.59431 -35.107 8.94544 -120 2 9.24682 0.159724 16.0687 7.59352 33.2076 -10.3682 -121 1 4.64785 1.66473 4.88429 20.0976 -32.3539 12.8345 -122 2 3.91841 2.23972 4.98678 -27.2909 21.6553 1.42112 -123 2 5.29938 2.12424 4.3745 8.75708 11.4615 -15.3566 -124 1 14.996 12.6195 16.4803 11.4842 8.30008 2.93566 -125 2 14.5677 12.8295 17.3315 -5.03395 -0.949445 -14.8823 -126 2 14.3989 12.5973 15.7101 -8.95177 1.91572 10.2236 -127 1 15.728 18.434 16.8656 -21.8007 21.3443 -35.9839 -128 2 16.2692 18.4514 17.6234 28.2096 -0.560819 33.2727 -129 2 15.2446 17.617 16.9069 0.184765 -20.6285 -2.2654 -130 1 1.36479 1.27889 16.6468 -16.7944 -10.044 -5.49533 -131 2 2.14801 1.79564 16.8219 8.14362 6.44014 2.70449 -132 2 0.693336 1.65446 17.2331 2.17778 -0.49248 0.882874 -133 1 18.205 4.38071 15.9717 -12.5383 1.08179 -4.34425 -134 2 17.9247 3.87865 15.1967 2.33887 0.121173 2.56773 -135 2 0.514445 4.3883 15.9876 8.17504 0.178033 -1.34417 -136 1 12.1632 17.0104 16.1415 17.8243 8.47052 -8.26904 -137 2 11.4339 16.4838 16.4748 -11.8796 -0.396392 0.7857 -138 2 12.1013 17.0682 15.1696 -12.6199 -2.93135 7.53111 -139 1 16.1201 2.6287 18.1864 3.80406 -3.99791 19.9987 -140 2 15.7935 3.50022 18.4009 -8.69312 10.1277 7.25942 -141 2 15.8264 2.47036 17.3057 -5.74882 -3.05042 -27.5508 -142 1 6.63908 13.8237 10.1059 1.54133 -19.2408 -0.896874 -143 2 6.60488 13.4547 10.9999 -2.4531 4.12781 1.41157 -144 2 6.6237 13.027 9.53669 -1.978 12.9815 -0.0933135 -145 1 10.1367 18.5192 2.71126 14.9692 1.08893 5.4249 -146 2 10.5375 0.290475 1.93143 -3.72697 -2.23961 5.76435 -147 2 9.31873 18.1319 2.42821 -14.2623 -5.70844 -7.57952 -148 1 3.05388 17.7183 6.14163 -17.3097 -9.85118 -22.5426 -149 2 2.24205 17.5791 5.58071 14.4512 3.50974 23.581 -150 2 3.73807 17.7208 5.46344 2.0394 5.03095 2.09251 -151 1 12.6118 16.8054 7.95495 4.58219 1.15158 -10.9791 -152 2 11.8555 16.2225 7.90842 -7.26482 -13.9478 -6.78863 -153 2 12.3849 17.4156 8.64585 -0.135632 15.5831 16.1371 -154 1 14.8975 15.2817 8.22586 -10.0433 25.2404 1.15436 -155 2 14.1016 15.8482 8.35876 13.2826 -12.9576 -5.35538 -156 2 15.2902 15.6258 7.39629 -1.79461 -13.1873 12.9757 -157 1 17.8242 18.245 0.290753 35.0262 5.69882 -22.3559 -158 2 18.562 17.7688 18.4584 -26.5201 3.44978 21.3008 -159 2 18.2553 0.461923 0.458274 -15.0979 -6.94564 5.00195 -160 1 0.811942 10.4929 1.40956 8.77271 16.3938 -17.0751 -161 2 0.0922351 9.87336 1.50209 -12.9574 -8.99075 8.33498 -162 2 0.506251 11.1761 0.770938 6.09002 -9.92994 11.4815 -163 1 1.80057 12.2567 3.3157 -0.00821892 -5.58838 -28.0373 -164 2 1.51905 11.5718 2.65287 2.57103 10.7079 19.8708 -165 2 2.13035 12.9839 2.7472 -5.7627 -4.92842 11.1942 -166 1 0.668516 17.2609 4.94683 -35.85 3.98858 25.1078 -167 2 0.0697466 18.0029 5.19004 17.5579 -5.46754 -17.9658 -168 2 0.309089 16.5456 5.51301 20.6369 3.3795 -13.3957 -169 1 1.1258 0.902495 9.33726 -12.4564 -3.06084 39.8122 -170 2 1.2842 0.722879 10.3134 -2.51149 4.27857 -26.5162 -171 2 0.280567 0.461704 9.18062 1.78742 1.97705 -4.09399 -172 1 16.751 2.38387 13.3212 3.93571 18.018 2.1702 -173 2 16.8889 2.64612 12.3995 3.13812 2.89192 3.07637 -174 2 16.5572 1.45381 13.2916 -4.67688 -18.3777 2.25645 -175 1 2.721 15.8932 12.0356 -10.4038 6.64935 25.1991 -176 2 2.99704 15.5189 12.8835 -2.56405 3.43208 -4.36032 -177 2 3.3254 15.553 11.3859 5.26998 -2.53603 -11.8474 -178 1 16.4132 15.6174 6.13158 -30.6236 -31.2218 7.18947 -179 2 17.2889 15.5331 6.46785 25.936 1.45578 4.51193 -180 2 16.388 16.3213 5.51027 2.55474 24.6255 -21.834 -181 1 5.75165 5.17156 11.8076 -10.0158 20.8309 8.83951 -182 2 5.58328 6.03799 12.2608 0.394348 -20.1746 -10.5178 -183 2 4.95414 4.6515 11.9927 8.5068 -2.87995 -2.26002 -184 1 15.1308 4.87532 0.804768 27.2949 -1.75024 -19.8676 -185 2 14.8777 4.72649 1.70618 -7.53991 -8.08598 20.9925 -186 2 14.4372 5.36761 0.397065 -18.333 11.5318 -5.57633 -187 1 16.3608 16.424 1.96087 0.545069 28.5814 -7.81874 -188 2 15.9402 16.8572 2.72963 9.40909 -7.94755 -2.88814 -189 2 16.7928 17.1706 1.4719 -7.75465 -17.4072 6.82817 -190 1 0.195497 4.8427 3.9016 -20.8114 -16.3238 -7.36148 -191 2 0.347935 5.77048 3.88737 2.90582 31.823 0.953261 -192 2 1.01225 4.48793 4.21241 18.9183 -15.2676 9.08502 -193 1 2.99687 15.0761 15.1729 -7.80035 25.004 -19.9303 -194 2 2.75027 14.6107 15.9518 -1.28992 -16.7566 29.7079 -195 2 2.55205 15.9391 15.3182 6.19364 -5.6546 -9.94962 -196 1 1.13925 14.6508 9.53021 19.9076 23.5081 3.98588 -197 2 2.07639 14.8825 9.77663 -29.323 -13.131 -7.88186 -198 2 1.04812 13.6993 9.55892 5.54263 -6.82879 4.76298 -199 1 13.5171 16.5199 11.5195 20.4201 8.76324 22.1576 -200 2 12.9867 17.257 11.2155 -0.855064 7.64635 -14.0191 -201 2 13.0442 15.7467 11.2378 -7.08331 -12.4379 -10.7884 -202 1 4.66723 1.48136 0.73322 23.0149 3.26353 10.1864 -203 2 3.99044 1.945 0.247475 -7.51763 5.99594 -9.81004 -204 2 4.21698 0.879204 1.33273 -6.6714 -6.19828 -5.18082 -205 1 1.48126 18.5865 11.8932 5.77456 11.9109 13.6761 -206 2 1.45047 0.509997 12.7065 -0.655319 -12.4833 -18.3988 -207 2 2.16842 17.9125 12.0331 -8.54366 2.69761 2.01722 -208 1 11.4638 10.1444 4.04596 -29.9846 -9.43843 22.7531 -209 2 11.586 10.5695 3.21678 -1.49335 12.1472 -28.3165 -210 2 12.3366 9.99459 4.35585 30.6386 -4.62302 8.08877 -211 1 8.15809 12.1698 3.75544 16.5318 -12.8496 -25.3624 -212 2 9.0168 12.5594 3.97136 -0.0903232 2.9732 11.2136 -213 2 7.55758 12.2779 4.48666 -4.55936 7.15494 21.2951 -214 1 14.57 4.03338 3.33424 -15.9396 -3.34089 -13.9779 -215 2 15.2475 4.30951 3.93522 14.2067 0.133456 17.245 -216 2 13.7488 4.35662 3.71839 -4.37522 2.77806 -1.52286 -217 1 5.69573 1.64484 7.55416 47.4861 32.5669 -28.9041 -218 2 5.02314 1.22164 8.01158 -49.1519 -34.4826 29.3881 -219 2 5.51675 1.48645 6.61188 -4.44278 2.0561 3.75596 -220 1 17.8757 1.08291 4.8338 -2.11434 0.172647 4.71576 -221 2 18.4455 1.46692 4.16357 3.67184 -2.89676 -9.33974 -222 2 18.0165 1.6381 5.60499 -0.396504 -0.0112538 6.48923 -223 1 6.85338 9.35555 4.52322 8.01303 -7.73923 12.5712 -224 2 6.71294 9.49068 5.48294 3.02765 -1.76203 -13.5451 -225 2 7.79052 9.06961 4.44068 -13.079 3.18293 -1.46589 -226 1 2.62197 14.8521 2.02937 -10.5221 3.39156 -23.0918 -227 2 3.43005 14.7674 2.51892 12.1264 -2.78802 16.39 -228 2 2.89555 15.1253 1.13827 -2.73698 -5.91865 10.4405 -229 1 17.3299 12.9421 13.1931 -12.7738 17.025 -7.03447 -230 2 16.4383 13.2606 13.4479 14.3464 -2.45707 -5.73497 -231 2 17.7945 13.7546 12.8897 -6.22536 -14.4165 5.27249 -232 1 14.8979 10.5619 1.48982 -11.9525 28.8063 14.5441 -233 2 15.3485 11.4081 1.81139 -13.0513 -30.8314 -8.90843 -234 2 13.9324 10.6539 1.67123 25.3412 1.8999 -4.23485 -235 1 5.67595 6.67872 4.55433 0.362155 18.5292 -10.9955 -236 2 5.7867 7.61135 4.29326 0.453279 -5.37291 7.09585 -237 2 6.40948 6.48302 5.14674 -0.086512 -6.41659 5.49044 -238 1 7.99316 8.32936 10.3099 -9.88556 -13.348 -36.673 -239 2 8.52429 8.77949 9.6279 3.30308 5.35046 16.0689 -240 2 7.32365 7.86355 9.75728 7.50693 2.48224 14.219 -241 1 13.4328 18.4778 5.70681 16.0844 -0.193399 -6.38488 -242 2 12.6986 0.421386 5.55211 -13.5651 7.65576 -7.58054 -243 2 13.084 17.8957 6.37412 -0.0453673 -15.2248 15.7361 -244 1 -0.0111344 2.60704 0.305045 25.2129 -30.2702 8.72131 -245 2 17.7164 2.72495 0.164021 -32.2143 -6.6311 -9.93678 -246 2 0.303096 3.48034 0.225751 24.1306 33.5707 -2.06333 -247 1 12.8325 10.9421 9.75806 8.08682 -36.6012 3.93532 -248 2 11.88 10.8422 9.79419 -10.8426 11.3849 -4.95145 -249 2 13.0795 10.0004 9.94273 0.259667 22.5692 -5.0531 -250 1 0.642026 12.1683 11.0609 4.45464 6.09796 -5.6804 -251 2 18.3356 12.2213 11.2584 6.06715 1.14224 4.76964 -252 2 1.15053 12.4132 11.8471 -8.72956 3.82018 2.8882 -253 1 5.19121 7.35128 13.362 14.2217 -1.26987 2.88721 -254 2 5.71731 8.09811 12.9969 -6.96977 -10.5111 6.72344 -255 2 5.67215 7.04852 14.1611 -4.50302 8.90065 -9.08298 -256 1 1.17753 6.82665 11.884 -6.96202 23.1207 3.27017 -257 2 0.332868 7.13942 11.4836 19.3553 -6.8941 9.30012 -258 2 1.59694 7.61812 12.3119 -7.65201 -17.5731 -13.8958 -259 1 15.4801 9.74186 12.3501 8.02403 -36.537 -7.5848 -260 2 15.2771 10.6331 12.1319 -8.61126 25.0623 0.312061 -261 2 15.6595 9.70704 13.2832 1.37326 2.5629 11.9963 -262 1 16.5169 12.594 5.50965 10.4637 -15.548 10.5874 -263 2 16.3074 13.4879 5.77305 -4.76715 16.3332 -4.64473 -264 2 16.4013 12.5274 4.55501 -3.26126 3.70708 -8.86796 -265 1 6.31292 9.82321 0.0853393 -0.254663 19.8779 15.0366 -266 2 5.47299 10.2624 0.316114 7.63969 -1.93852 0.671735 -267 2 6.95815 10.0698 0.784254 -6.58085 -1.04763 -9.09577 -268 1 12.2316 6.09819 4.0135 -11.5327 11.7492 -3.18772 -269 2 12.1819 6.93481 3.49894 6.0574 -18.2652 4.97925 -270 2 11.3139 5.7855 4.02535 4.75129 -2.10791 -0.415098 -271 1 0.346102 12.8439 0.0895734 -4.86896 0.353582 5.39062 -272 2 18.7507 13.4631 0.799834 -0.48412 -1.67542 -1.66039 -273 2 18.3682 13.0274 18.0218 -2.69393 2.08889 -5.2677 -274 1 3.5489 0.022651 8.64264 14.8213 -2.21723 6.15117 -275 2 3.34146 18.2537 7.79412 -1.37888 1.54429 -1.85278 -276 2 2.69807 0.312924 8.99074 2.91061 0.134312 -8.36673 -277 1 7.48275 17.4677 4.49597 -9.82961 -11.4008 2.47905 -278 2 7.76172 18.3639 4.65831 -0.473756 11.2371 0.709742 -279 2 7.61951 17.3416 3.55584 -1.72206 -2.44101 -5.98946 -280 1 9.27482 17.1419 12.2002 -29.9673 17.8198 -3.75997 -281 2 9.29449 16.2474 11.8858 2.76409 -17.0257 -9.00951 -282 2 9.96887 17.232 12.8306 24.004 1.27191 14.3563 -283 1 13.3881 13.0638 7.94543 23.8544 1.05207 16.0454 -284 2 13.4911 12.3591 8.61055 -7.80977 1.42534 -8.25381 -285 2 14.1677 13.6583 8.10929 -22.3675 -6.64423 -7.05202 -286 1 14.8196 2.98416 15.4059 10.9247 4.82989 11.3692 -287 2 14.1977 2.30622 15.182 -14.8004 -11.8419 -2.86461 -288 2 15.3715 3.04555 14.6288 11.3419 0.403673 -8.50968 -289 1 9.89007 15.644 16.9507 -0.476448 -13.1737 2.9886 -290 2 10.2689 14.811 16.6236 0.33136 1.14394 -2.50282 -291 2 9.50974 15.3862 17.8064 -0.51987 6.75584 -0.702029 -292 1 11.2404 8.49746 16.6126 -11.0388 -24.1902 -5.6141 -293 2 10.5493 7.95233 16.1656 11.7734 11.5748 6.95591 -294 2 11.5411 7.95338 17.3605 -0.459906 4.27214 -6.12679 -295 1 3.94653 18.1828 16.8275 -12.5536 19.575 -10.0724 -296 2 4.49583 17.6028 17.3635 4.26127 2.6886 8.36922 -297 2 3.95977 0.456308 17.1729 5.72776 -19.9128 0.46306 -298 1 2.2132 4.22212 8.91052 -3.52394 3.62108 -17.0138 -299 2 3.14576 4.09878 8.74947 8.67559 -2.34434 0.767855 -300 2 2.06536 4.03466 9.83165 -0.817379 -1.75645 17.2153 -301 1 9.87247 10.3712 9.74928 14.7683 -30.296 -5.49075 -302 2 9.62147 11.2221 9.45607 -13.6864 32.2476 -14.4563 -303 2 9.99394 10.4206 10.6874 0.365841 -1.43755 21.5864 -304 1 9.68376 0.92477 10.8522 -9.86416 -7.8375 -9.37303 -305 2 9.18791 0.169256 11.2055 11.1043 -0.796798 3.35444 -306 2 9.09399 1.23638 10.1435 10.2069 6.90097 4.69651 -307 1 9.16769 15.091 10.1956 22.4355 7.87639 6.21774 -308 2 8.9696 15.9691 9.88131 -3.17938 11.9605 -8.33522 -309 2 8.32743 14.6622 10.1389 -19.5916 -16.662 -1.08184 -310 1 0.85922 9.69743 10.2442 32.6336 -47.5631 -25.4673 -311 2 1.02374 10.6105 10.3992 -2.53948 25.7241 9.50189 -312 2 1.72313 9.35148 9.87448 -35.4256 9.68482 16.6576 -313 1 17.0256 4.81986 8.08308 31.6348 -31.2729 -9.48192 -314 2 16.3215 5.37214 8.33224 -31.3655 27.4802 10.3117 -315 2 16.9319 4.0155 8.6004 0.768816 2.34372 -1.45333 -316 1 14.8081 14.6794 0.153243 -2.85725 -11.5952 -11.9613 -317 2 15.2092 15.2804 0.771003 11.383 9.73034 15.7651 -318 2 14.0408 14.3115 0.591288 -7.92269 -3.99881 6.06231 -319 1 3.80416 11.0019 9.56526 0.623941 6.68377 2.11405 -320 2 3.77619 11.4642 10.4186 -0.043788 -6.16761 3.62327 -321 2 3.31763 11.5705 8.95624 -4.54045 6.84371 -3.4313 -322 1 11.3158 10.7476 1.45776 10.9951 -9.43983 2.74041 -323 2 11.5252 11.5694 1.01773 6.8042 14.5185 -3.76913 -324 2 10.3718 10.6573 1.35733 -14.9091 -3.38451 -2.45366 -325 1 13.1832 7.19978 12.6897 5.92706 -14.8401 5.32281 -326 2 14.1145 6.87754 12.7085 -13.0936 9.37511 -3.26372 -327 2 12.6462 6.38983 12.7968 5.91866 7.22274 -2.53959 -328 1 9.61767 1.88189 0.936979 -6.6056 8.12678 -33.3335 -329 2 8.75647 1.76915 0.468433 15.5153 -2.73343 13.4493 -330 2 10.2273 2.17983 0.230861 -6.38326 -0.489196 14.1696 -331 1 10.6523 13.47 4.56634 -17.7163 6.61907 -5.84307 -332 2 11.5562 13.1849 4.68206 11.5009 -9.86279 4.07703 -333 2 10.5151 14.0877 5.29021 -1.44258 0.681598 7.9468 -334 1 14.5213 1.69385 10.9785 0.412416 12.5139 1.3055 -335 2 15.3159 1.33414 10.5754 1.96072 -4.24727 -0.900333 -336 2 14.7412 2.63918 11.0728 -6.13642 -3.41388 -3.76294 -337 1 14.5042 12.0777 11.6111 -12.2061 0.510996 31.5423 -338 2 15.1827 12.4648 11.0978 29.2487 15.6657 -21.0239 -339 2 13.909 11.6953 10.9807 -16.843 -4.29027 -12.6849 -340 1 8.18401 5.11068 9.87002 -0.676892 -7.65738 -3.35075 -341 2 7.33939 5.06675 10.3357 0.521056 4.21206 1.1001 -342 2 8.29842 4.21721 9.50312 -0.00697362 5.6522 3.71152 -343 1 1.5768 16.9623 18.4443 13.7844 -6.06932 -11.1938 -344 2 2.08688 17.3314 17.6994 -1.29344 -1.55823 6.9248 -345 2 1.72478 16.0021 18.3853 -4.19272 5.84443 -4.03385 -346 1 1.47359 17.3466 15.3156 -41.3862 18.9515 21.4522 -347 2 1.38751 18.1942 15.8376 11.356 -22.4463 -17.1221 -348 2 0.531998 17.0202 15.2731 27.9598 4.08453 -2.72162 -349 1 3.56251 5.80266 6.06315 1.23781 -30.1986 0.952301 -350 2 2.9922 6.42371 6.50913 -3.22231 11.6367 6.59476 -351 2 4.22501 6.28135 5.5614 1.05528 7.23928 -6.44245 -352 1 12.5723 9.4951 14.2463 -14.1947 49.7353 4.36555 -353 2 12.9086 8.77822 13.7576 17.8642 -40.1771 -16.3075 -354 2 12.2963 9.16979 15.1004 -1.36164 -11.5003 11.0357 -355 1 4.07044 15.2648 6.99086 -8.22484 -15.5272 10.3185 -356 2 3.65725 16.0904 6.74002 -9.77102 8.77549 -2.61135 -357 2 5.00026 15.4315 6.88928 20.0063 2.47059 -3.54324 -358 1 0.744606 8.73408 15.0763 0.0218964 -5.95646 -3.10884 -359 2 0.519262 9.66197 15.1074 -7.84082 12.7234 2.89932 -360 2 1.47025 8.73132 14.4431 5.87969 -4.51966 -2.6491 -361 1 12.9306 8.27919 10.1905 8.08936 2.40022 19.7343 -362 2 13.779 7.90886 9.87037 -9.22858 -4.32337 9.26771 -363 2 12.8604 8.07471 11.1624 7.69549 -2.50096 -25.1681 -364 1 15.3235 7.85492 3.5497 18.4153 32.411 -54.1913 -365 2 14.4745 7.6657 3.15314 -16.0822 -13.4855 9.94503 -366 2 15.5116 7.64082 4.44166 -12.2255 -21.7424 34.152 -367 1 17.2256 6.71185 18.6385 13.0601 3.46678 -1.24204 -368 2 16.7837 5.9846 0.423329 -10.4159 -11.046 2.92977 -369 2 16.5307 7.32814 18.3852 -6.78357 2.8142 -3.2779 -370 1 8.8964 6.96848 7.83902 16.0931 16.0227 -2.80611 -371 2 9.83265 7.28699 7.8278 -17.1093 -4.77101 0.707558 -372 2 8.79691 6.46408 8.64714 -0.939429 -8.3316 9.69843 -373 1 12.4084 0.523138 1.23768 -2.06115 0.0733923 -7.11266 -374 2 13.1872 0.998726 1.54472 7.23891 -2.91784 -1.02165 -375 2 12.4662 0.537618 0.274809 1.69654 -3.93261 2.5223 -376 1 5.65468 15.0902 14.5334 3.02676 -25.5773 -0.125585 -377 2 4.72407 15.1616 14.7961 0.127409 2.72757 -0.91443 -378 2 5.99013 15.9712 14.3886 3.52657 16.2654 -6.40367 -379 1 3.82399 6.39797 1.75512 3.78691 -6.14258 3.26006 -380 2 3.37829 7.15763 1.38654 -6.41374 16.3556 -5.84968 -381 2 3.97609 6.61981 2.67876 -1.82166 -0.0414506 2.69272 -382 1 3.91801 11.4637 12.3808 6.26728 1.11409 -8.60855 -383 2 4.78798 11.8777 12.4982 -7.30712 -3.21292 -1.54071 -384 2 3.30212 12.087 12.775 -5.64928 0.778082 5.20377 -385 1 5.29676 3.85177 15.8189 3.43828 -31.27 -8.27082 -386 2 6.03967 3.23378 15.6029 -11.8461 12.1043 0.727598 -387 2 5.68429 4.70341 15.931 13.0054 23.274 1.41344 -388 1 14.2193 10.1559 4.56622 -21.9238 17.9967 10.7876 -389 2 14.2923 9.81422 5.45847 5.67938 -3.41822 10.3914 -390 2 14.6614 9.51741 4.03067 14.2685 -12.4061 -15.9356 -391 1 7.6994 17.3598 9.13069 2.58566 -7.07749 -1.38218 -392 2 6.9688 17.7373 9.6086 -11.208 -1.02501 12.7072 -393 2 7.91331 18.0249 8.47917 9.78731 5.09099 -13.1281 -394 1 4.50671 14.5226 3.97805 12.528 -25.4608 -46.8355 -395 2 4.48015 15.4086 4.24602 -0.161492 47.21 12.2969 -396 2 4.35306 14.022 4.74858 -6.07017 -24.5156 30.0525 -397 1 14.1411 7.46132 15.8217 -22.5264 -9.25347 -2.17647 -398 2 14.9826 7.35759 15.4044 20.5288 -0.540355 -7.58788 -399 2 14.3421 7.83921 16.6731 3.72262 6.08742 11.7763 -400 1 2.98184 18.372 1.90579 -20.1648 -30.237 -17.2141 -401 2 2.43548 17.7555 1.32026 19.5303 24.385 16.7936 -402 2 2.33791 0.236975 2.41065 -5.95562 0.980031 -0.0237849 -403 1 7.99445 1.58502 4.53075 18.7977 0.504684 -14.6733 -404 2 7.48712 1.99417 3.8192 -9.17378 0.780153 1.87786 -405 2 8.88078 1.50473 4.13387 -7.12077 1.17171 10.2984 -406 1 2.41951 14.1599 17.7056 22.0207 15.2121 -4.13121 -407 2 1.68443 13.6195 17.9516 -15.3327 -12.8663 8.26013 -408 2 3.18525 13.6986 18.0793 5.57496 -0.0710026 -2.65101 -409 1 0.908587 1.85846 13.8858 -0.0793858 -1.94323 14.6669 -410 2 1.14821 1.59902 14.7928 -3.46921 3.66635 -7.67361 -411 2 18.5942 2.00299 13.9058 4.01903 -0.250224 -6.72878 -412 1 4.32702 0.129386 13.8829 -0.0770511 3.08332 3.55447 -413 2 5.24833 18.5067 13.8286 4.90059 -4.64875 -2.30826 -414 2 4.05486 18.5232 14.7746 -2.81766 -1.27361 1.32354 -415 1 7.27357 0.854459 18.3804 -15.3869 4.3045 -1.1218 -416 2 7.16992 0.518993 17.4624 3.36336 5.55626 15.3605 -417 2 6.40185 1.20099 18.6914 11.5657 -10.6186 -10.5297 -418 1 15.9542 18.4046 13.9208 -25.3022 5.029 -14.7602 -419 2 15.0075 18.5254 13.735 13.8644 -2.42428 -4.09563 -420 2 16.0061 18.5076 14.8614 8.67486 -1.51607 21.0166 -421 1 10.2392 4.55204 16.2801 10.7238 -8.25817 -3.6178 -422 2 11.196 4.37813 16.4864 -24.802 4.89259 -9.76699 -423 2 9.86858 3.73489 15.891 10.2726 5.88423 10.0044 -424 1 15.9238 17.7149 4.45644 2.75189 -23.1215 -12.8271 -425 2 16.5168 18.4535 4.47728 14.6813 18.6917 2.39924 -426 2 15.0936 18.0469 4.76398 -21.0845 8.87368 10.3462 -427 1 6.95648 17.503 13.9077 -51.9825 -4.38955 -3.71365 -428 2 7.39002 17.773 14.6913 25.8751 9.72049 29.5532 -429 2 7.60747 17.4983 13.2335 27.2317 -2.92469 -23.3456 -430 1 13.2071 6.48879 6.54043 12.3601 -8.29587 -18.0485 -431 2 14.1818 6.5258 6.42811 -17.7974 6.95191 3.55269 -432 2 12.8555 6.35956 5.62691 5.37067 1.68412 18.5111 -433 1 7.86742 2.30794 9.39626 -5.35093 5.07188 8.74379 -434 2 7.30782 2.2926 10.1983 5.67726 -4.12754 -5.74363 -435 2 7.33716 1.92062 8.69482 -5.03183 0.0809058 -6.36949 -436 1 15.2078 14.7586 13.7432 0.832397 -4.30074 -2.87903 -437 2 14.8858 14.9257 14.6258 -3.94452 3.16733 11.6107 -438 2 14.9517 15.5204 13.2236 -2.78606 2.09491 -5.66724 -439 1 9.4202 8.34719 3.8485 -22.8652 4.71801 -4.87246 -440 2 10.1988 8.89706 3.87201 15.3465 4.97444 3.28263 -441 2 9.69606 7.44575 4.01411 1.53448 -7.03017 -1.02937 -442 1 17.7384 13.5884 16.4052 -11.7067 -11.536 8.32036 -443 2 16.7673 13.5542 16.377 3.38001 -6.87595 1.27552 -444 2 17.9496 14.385 15.9274 3.88108 14.0768 -7.71607 -445 1 4.90559 10.5521 2.87839 21.3367 -20.8737 -11.4011 -446 2 5.623 10.1254 3.38432 -4.07258 6.62764 -8.01418 -447 2 4.62886 11.2624 3.4373 -4.18877 12.0113 9.86562 -448 1 3.72998 8.3995 9.96949 0.206562 0.552242 5.18998 -449 2 3.80623 9.33185 9.71276 -0.050758 -4.34606 1.0469 -450 2 3.86748 8.41721 10.9275 -4.36654 -3.13592 -2.04235 -451 1 15.965 6.95365 5.95266 -6.26742 1.66997 1.55481 -452 2 16.7698 7.37181 6.25298 11.0034 6.69643 7.83926 -453 2 16.2161 6.06091 5.70554 3.02292 -8.38979 0.185448 -454 1 15.1879 7.19538 9.00463 -16.574 -33.0638 16.9279 -455 2 15.9728 7.55664 9.38717 21.7076 13.0833 8.35481 -456 2 14.9649 7.65827 8.21955 0.87619 20.3483 -26.3308 -457 1 6.20656 12.8742 12.7233 -2.45823 6.18764 -5.3718 -458 2 6.79799 12.2543 13.1384 18.4055 -9.75357 3.10315 -459 2 6.13621 13.6122 13.3363 -4.91508 8.57981 5.63651 -460 1 12.128 4.53555 13.1062 -17.5662 -8.78193 22.9206 -461 2 12.3906 4.63486 14.0411 2.44404 0.930561 -9.75427 -462 2 11.3004 4.01263 13.1714 14.0583 8.15169 -11.9376 -463 1 11.4184 8.10098 7.95437 7.14359 -3.91624 -16.2991 -464 2 12.1028 7.60478 7.4673 -7.16754 1.39876 -0.578178 -465 2 11.8093 8.18067 8.82553 -2.79742 2.89488 8.77133 -466 1 17.0514 10.8651 7.58728 -24.1088 0.784299 26.3012 -467 2 17.8144 10.3384 7.41217 20.5663 -15.9736 -11.9321 -468 2 16.8601 11.4269 6.84052 2.19633 6.48519 -17.1676 -469 1 5.231 18.0993 10.8546 26.455 4.8965 -4.82813 -470 2 4.8195 17.6908 11.6007 -11.7048 -9.88744 14.1218 -471 2 4.63699 18.0004 10.1206 -18.4061 3.17503 -16.8763 -472 1 7.59767 17.4436 1.69759 5.72815 6.19172 -16.2775 -473 2 7.89477 16.6568 1.18579 0.971667 15.0969 7.35096 -474 2 7.65141 18.2352 1.10536 -4.88626 -20.2664 5.47735 -475 1 1.93145 12.9234 13.6206 5.60545 -3.12143 -21.3855 -476 2 1.4749 12.3281 14.2061 -8.56587 -7.9862 10.2726 -477 2 2.17547 13.6903 14.1341 4.19375 11.0678 7.71152 -478 1 9.43748 6.79443 14.8327 33.0335 -30.4644 -7.71462 -479 2 9.91196 6.01751 15.25 -19.5648 18.6507 -3.60269 -480 2 9.7502 6.76156 13.9011 -9.65438 10.9618 10.9707 -481 1 15.2831 4.34212 10.7772 21.179 15.7439 -2.01388 -482 2 16.2293 4.27243 10.5111 -19.8675 -5.23 11.4528 -483 2 15.2971 5.09975 11.4021 -5.00612 -14.3562 -6.14057 -484 1 11.351 6.2072 0.109577 23.6613 28.7979 6.66193 -485 2 11.4872 5.27024 0.0694097 -6.21323 -21.6319 -6.22108 -486 2 10.4676 6.44004 18.4761 -18.3883 -9.25121 -2.88973 -487 1 18.5357 11.4228 14.9398 26.7643 -26.8403 31.1109 -488 2 18.0597 11.723 14.1947 -18.2778 17.0129 -29.9513 -489 2 18.4532 12.1424 15.5699 -5.23995 5.81903 4.32114 -490 1 7.05668 9.28071 7.31234 -6.58466 7.4517 -4.55549 -491 2 6.71011 8.47084 7.6978 -4.31789 -6.13087 1.68327 -492 2 7.98804 9.13135 7.18438 15.6823 -2.37616 0.276954 -493 1 18.324 15.3331 12.2569 -7.46978 -1.64803 5.36971 -494 2 0.564477 15.5946 11.9899 10.9599 1.36641 -5.51497 -495 2 17.7284 15.6281 11.5548 0.957946 6.58656 -2.69515 -496 1 16.4958 4.38611 5.25998 2.69003 14.057 -30.634 -497 2 16.6253 3.88668 6.0538 7.32023 -9.57738 16.711 -498 2 17.3371 4.41488 4.75201 -4.14044 -1.60108 11.4247 -499 1 17.7073 3.15256 10.779 -3.63642 -2.40486 -9.15002 -500 2 18.6235 3.40441 10.9111 8.43018 2.88916 7.88185 -501 2 17.7389 2.35032 10.2471 -2.89329 -5.91517 0.580451 -502 1 12.2813 18.6401 10.1181 2.89516 -35.5496 -8.35074 -503 2 11.4703 0.383955 10.4005 -29.8535 10.9583 6.97968 -504 2 12.9196 0.674429 10.2218 25.4798 25.6209 2.989 -505 1 10.3974 9.74216 12.5073 0.112101 -17.0368 -3.21727 -506 2 11.1947 9.82557 13.039 4.39701 4.68697 5.66162 -507 2 10.3035 8.76836 12.4158 -2.37231 15.8308 -1.56525 -508 1 0.663588 2.73535 7.12598 -12.3374 1.53361 -6.62113 -509 2 0.367817 3.62684 7.37457 5.09588 -7.68469 3.80292 -510 2 0.956045 2.28157 7.92852 1.53616 1.67998 2.79736 -511 1 0.311147 15.2759 6.88171 -13.4592 45.4783 4.03261 -512 2 0.500617 15.614 7.76495 4.81164 -9.60864 4.06796 -513 2 0.558697 14.3764 6.88071 13.8097 -37.6199 -4.57419 -514 1 17.0548 6.97395 15.0744 4.20776 -1.94343 -1.58424 -515 2 17.8177 7.57453 14.9855 -5.12063 -2.20736 -0.0554095 -516 2 17.4111 6.17613 15.4934 -0.113823 0.922547 0.618491 -517 1 9.1503 12.5213 8.01319 -14.1189 2.82879 0.278945 -518 2 9.53356 11.9725 7.3299 10.3093 -11.5802 -1.96405 -519 2 8.24075 12.6139 7.71394 -0.988228 2.45183 6.21614 -520 1 1.17609 1.70844 2.83295 3.23913 -2.31621 -1.89882 -521 2 1.09855 2.22978 2.02752 -9.74566 -1.77621 -3.35395 -522 2 1.86202 2.13223 3.34238 5.26299 8.17365 10.1548 -523 1 4.09291 15.1504 9.8922 18.1507 -7.2721 -6.40054 -524 2 4.03036 15.1629 8.92399 -1.00826 2.87435 -0.463193 -525 2 4.99389 14.8146 10.0732 -8.74469 0.915467 -5.31212 -526 1 7.37772 2.25117 14.7222 3.22505 8.21162 1.39777 -527 2 7.09502 1.54536 14.1374 1.57311 -0.181539 -4.41158 -528 2 7.85635 2.90205 14.1691 -14.4419 -9.06063 9.37489 -529 1 18.4006 14.5833 2.15968 -9.78242 8.50711 -1.4388 -530 2 0.62994 14.8842 2.46282 -4.8788 5.17113 -0.292034 -531 2 17.7517 15.3351 2.17575 17.725 -12.6913 0.414249 -532 1 9.99197 2.68277 12.9223 -2.58103 11.7713 -8.17336 -533 2 9.96789 2.1685 12.101 0.346485 -5.49174 3.23624 -534 2 9.29748 3.35451 12.7936 3.47695 -5.23648 4.96996 -535 1 2.96299 8.91941 13.096 19.2939 -0.203164 0.561242 -536 2 3.4486 9.7527 12.8428 -15.067 -18.0348 7.07188 -537 2 3.65865 8.27445 13.3679 -12.9331 14.6867 -6.35999 -538 1 3.26147 8.578 3.77304 6.38222 5.3653 -9.36202 -539 2 3.78874 9.26676 3.32736 -9.65467 -7.00498 -1.39723 -540 2 3.24393 8.8647 4.68594 3.08129 -4.64857 6.90262 -541 1 5.77287 7.24333 8.61048 -1.78661 -5.00814 9.07462 -542 2 5.68022 6.28289 8.53661 4.0016 -1.85755 -4.86386 -543 2 5.00276 7.50215 9.14094 4.61323 4.45406 -2.92895 -544 1 14.8793 1.52937 1.85035 -12.7334 -14.0835 12.9397 -545 2 14.819 2.16152 2.5876 10.8144 6.55959 -13.4181 -546 2 15.5594 1.73936 1.19754 -2.84827 11.2594 2.6977 -547 1 8.5607 15.0611 0.725284 0.46926 -2.1008 2.83341 -548 2 9.29259 14.9147 1.35885 -7.99161 6.01774 -7.32206 -549 2 7.81927 14.5289 1.05772 1.7687 -2.35649 0.826934 -550 1 15.4921 1.3993 7.20702 14.746 2.01238 2.95597 -551 2 14.8484 0.891915 6.72418 -10.4472 -9.96976 -7.88743 -552 2 15.1077 2.27361 7.28199 -8.00989 7.94424 8.07076 -553 1 5.01058 12.9585 18.4386 -15.8567 -4.4202 8.08993 -554 2 5.4193 13.0053 0.667327 2.46468 -0.195888 1.58163 -555 2 5.59523 13.4446 17.8643 8.60291 1.11734 -4.66644 -556 1 15.4019 8.61725 18.0949 -10.0539 -8.80276 13.7753 -557 2 15.8344 9.23888 17.5182 6.53635 7.63687 -15.5634 -558 2 15.1418 9.16559 0.203922 1.58583 0.47418 3.18719 -559 1 12.0525 3.11208 18.2861 7.73999 -14.4321 9.61497 -560 2 12.4007 2.82569 0.495607 -5.57788 10.1171 1.38067 -561 2 12.4066 2.43321 17.7002 -1.56388 4.26076 -9.69121 -562 1 13.1688 12.6857 5.1494 7.31226 -7.20074 3.10637 -563 2 13.4985 11.8462 4.78426 1.65488 6.62932 1.41885 -564 2 13.3525 12.6203 6.1046 -3.90991 6.43934 -4.24709 -565 1 6.08926 7.21668 0.130178 -1.88627 11.2856 16.2629 -566 2 6.12641 8.19603 18.8427 -2.9512 -23.7133 -6.32338 -567 2 5.32645 6.95656 0.679872 3.54107 -2.60359 -10.7249 -568 1 17.6547 15.8703 14.9132 16.2429 2.82715 17.6162 -569 2 16.6953 15.9075 15.0555 4.78919 3.7515 -14.6122 -570 2 17.9345 15.7768 13.9856 -18.469 -1.14955 -2.42085 -571 1 13.1468 0.885591 16.7291 -10.7864 15.024 2.10847 -572 2 14.1008 0.813897 16.7431 10.5998 -4.62802 3.60151 -573 2 12.8375 18.6536 16.4909 -4.88764 -9.34618 2.57866 -574 1 10.8908 14.4992 7.43136 -2.2343 -7.03539 12.0134 -575 2 10.0835 14.2065 7.92308 22.5278 2.1252 -13.3834 -576 2 11.6003 13.8396 7.60224 -11.7269 11.3777 -3.99947 -577 1 17.6181 8.42363 2.12766 -11.9935 -3.6797 -6.77545 -578 2 16.7343 8.37762 2.55285 14.0369 1.72981 -7.6286 -579 2 17.5632 7.81953 1.35766 3.76606 6.32419 13.0143 -580 1 12.3929 7.83138 2.01819 4.71096 17.5308 0.40727 -581 2 12.1717 8.7272 1.7221 -1.13772 -2.1217 4.67191 -582 2 11.9464 7.25327 1.39471 0.282935 -6.68024 -6.10503 -583 1 12.0275 14.6478 10.4009 38.9809 -24.2439 -10.9711 -584 2 12.337 14.044 9.6932 -4.28518 13.1756 12.472 -585 2 11.1105 14.7441 10.2592 -43.0899 4.37787 -4.57767 -586 1 6.8265 6.93238 15.5327 -27.6581 -7.97269 5.64053 -587 2 7.73103 7.08984 15.3178 26.4357 1.09681 -7.32033 -588 2 6.59533 7.63547 16.1384 -2.46814 3.13878 5.80205 -589 1 7.96021 4.51991 13.281 5.98272 36.635 4.98876 -590 2 7.18773 4.72006 12.7149 7.22552 -5.34662 5.9239 -591 2 8.2239 5.40342 13.6709 -8.7699 -31.8396 -11.1478 -592 1 13.3799 12.1942 14.3144 0.413244 -2.26196 2.0512 -593 2 13.2473 11.2333 14.3131 -4.23433 1.2327 0.0241848 -594 2 13.7366 12.3802 13.4362 1.03232 3.06063 -1.77089 -595 1 14.6196 9.43974 7.2819 12.1284 19.1611 12.5008 -596 2 15.4631 9.9012 7.50833 -13.143 -10.3991 -7.78335 -597 2 13.9498 9.89967 7.80701 0.241302 -5.62146 -3.59828 -598 1 12.6688 16.8855 3.24635 -1.47445 -34.5545 -0.541717 -599 2 12.9124 17.3724 4.01195 4.0393 16.1159 25.6755 -600 2 12.6994 17.4999 2.53895 -2.71389 24.0914 -25.4271 -601 1 1.00064 7.12258 17.3474 25.8989 -13.4919 10.9638 -602 2 0.199171 6.81692 17.7654 -17.9333 6.12878 2.90109 -603 2 0.781412 7.72916 16.646 -4.92956 7.36441 -13.84 -604 1 12.947 4.88013 15.7213 -21.2986 7.3754 -0.931645 -605 2 13.7769 4.45629 15.8524 19.8874 -20.9291 -0.114876 -606 2 13.1805 5.80207 15.7513 2.74699 20.2475 2.05037 -607 1 2.36441 3.38825 5.1495 13.4973 -9.76059 -50.575 -608 2 1.87697 2.96062 5.81278 -27.3053 -18.1487 33.2377 -609 2 2.7907 4.09602 5.58982 16.1263 32.9476 11.4061 -610 1 8.23368 10.9868 13.6471 -16.5646 12.9957 -7.98974 -611 2 8.32411 10.9316 14.5895 -0.490848 -4.77914 16.6738 -612 2 9.07298 10.6867 13.3074 11.7511 -8.07538 -9.61613 -613 1 13.0107 1.52025 13.2616 -13.3177 -0.0328213 18.9383 -614 2 13.4383 1.61013 12.4179 13.267 -2.68379 -13.3373 -615 2 12.5185 2.34771 13.3673 3.11016 -7.04189 -1.75869 -616 1 6.59377 13.5764 2.15874 -7.12741 11.9903 -27.1264 -617 2 6.00679 13.9468 2.8128 -10.8754 6.0075 10.3445 -618 2 7.2163 13.0692 2.66145 9.56033 -10.8956 7.78491 -619 1 15.8548 6.42593 12.5881 24.8624 13.3217 16.2273 -620 2 16.4838 6.96617 12.0488 -16.1868 -9.65605 6.77151 -621 2 16.2214 6.49686 13.512 -7.09801 -2.27572 -23.2114 -622 1 16.7956 0.692247 9.54535 7.46915 17.7641 2.49637 -623 2 16.5452 18.5156 9.96298 -0.0131793 -20.516 -0.238231 -624 2 16.2976 0.789947 8.72228 -2.61192 -2.24486 -4.75056 -625 1 6.11318 11.627 8.27064 9.91462 44.2797 -2.20509 -626 2 5.35292 11.2978 8.70378 -29.3613 -6.33495 17.8965 -627 2 6.52877 10.8496 7.97791 23.4734 -34.8725 -13.0112 -628 1 2.81389 8.67751 0.381383 10.1752 -8.74242 -1.84173 -629 2 2.33278 8.32184 18.2713 -4.10181 -2.8979 1.44899 -630 2 2.25425 9.35695 0.757627 -6.74555 6.18422 5.10447 -631 1 10.1136 10.3815 6.5683 -3.97178 -1.84722 1.40214 -632 2 10.6776 9.73953 7.0164 -1.23094 -3.31757 4.86865 -633 2 10.3499 10.3203 5.64027 4.41826 3.29106 -4.73543 -634 1 6.84727 15.7748 6.6764 -14.7135 -11.7826 9.04786 -635 2 7.02398 16.1904 7.53289 5.38031 2.81892 -3.47781 -636 2 6.91879 16.4549 5.99719 9.07918 3.78678 -4.16926 -637 1 6.52182 12.8956 5.7943 0.541827 3.55761 1.99739 -638 2 6.55778 13.7774 6.19915 3.14226 -1.33255 -2.96851 -639 2 6.13082 12.3068 6.44859 -0.859963 5.03094 3.84811 -640 1 16.7567 12.5314 9.76383 -4.64367 0.23861 8.75508 -641 2 16.9908 11.8798 9.10281 -4.06168 -8.34407 -5.30318 -642 2 17.2898 13.2837 9.5332 2.7418 12.1851 0.697411 -643 1 6.23186 2.86269 2.75104 2.97881 8.48666 -1.38882 -644 2 6.52094 3.78037 2.52233 -11.0321 -17.6889 -1.77294 -645 2 5.63962 2.52843 2.04764 8.59188 6.36028 2.68011 -646 1 10.7835 3.03466 3.2504 -5.97107 -1.61798 -4.71292 -647 2 10.2628 3.82076 3.45136 1.61481 0.158577 0.983482 -648 2 10.306 2.59283 2.52669 4.73542 2.88639 2.9637 -ITEM: TIMESTEP -80 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.82629 6.70343 17.8553 -15.1071 8.15122 13.6853 -2 2 7.99416 6.85162 18.349 10.9787 -1.12299 -6.8679 -3 2 8.57507 6.09547 17.1643 3.5075 -8.11573 -6.04158 -4 1 0.137192 8.33532 6.74353 12.0191 -20.4001 -6.39938 -5 2 0.250097 8.10589 5.79669 -2.0008 6.10915 10.6578 -6 2 0.653601 7.63933 7.2162 -12.3825 18.3147 -3.0068 -7 1 8.60149 0.29664 6.93203 12.1667 -9.17994 12.1946 -8 2 9.52501 0.228788 6.64808 -5.75422 4.1152 -0.42095 -9 2 8.21226 0.977159 6.3883 -5.16274 6.48178 -7.47064 -10 1 6.50463 1.68869 11.7262 -16.2706 -7.92373 -2.85274 -11 2 5.9813 2.3145 12.2428 -2.71472 -2.47934 -1.80386 -12 2 5.86927 0.986784 11.4354 16.7384 10.0214 6.53226 -13 1 6.9131 5.55027 2.37535 3.77295 -5.39511 9.11334 -14 2 6.43692 5.84081 3.17655 -0.921031 3.98795 -14.1822 -15 2 6.69543 6.14979 1.6478 1.12895 -1.48609 4.32855 -16 1 16.196 10.2371 16.1388 -31.5516 2.77844 19.9706 -17 2 16.8915 10.3643 15.5412 37.4 6.14414 -23.2997 -18 2 15.8469 11.1288 16.3108 1.55641 -10.2432 -3.37881 -19 1 10.775 14.9631 2.31622 -5.5944 -0.094079 7.63582 -20 2 10.598 14.4521 3.12767 5.78422 3.02899 -5.84463 -21 2 11.1066 15.8146 2.64245 2.43259 -3.51347 -1.1859 -22 1 17.165 8.21001 10.8825 14.1674 -5.9779 -9.25967 -23 2 16.5809 8.83567 11.3092 -8.03296 12.2385 6.15632 -24 2 17.9797 8.71133 10.6858 -5.20793 -0.650283 -1.86008 -25 1 14.6097 15.9558 16.401 14.8916 -7.54315 9.24646 -26 2 13.6847 16.2494 16.4321 3.25844 -2.02272 0.00765398 -27 2 14.8063 15.4932 17.2527 -13.7355 5.39716 -16.4095 -28 1 12.117 13.3155 0.580411 -1.24587 -0.207976 3.78722 -29 2 11.7909 13.4576 18.3369 0.57388 -2.32058 -15.0609 -30 2 11.6242 13.9531 1.10951 4.78037 0.383607 7.31905 -31 1 9.34228 5.488 3.85121 53.6451 1.51077 14.3512 -32 2 8.91013 5.51861 4.6996 -19.4462 -5.34697 10.1126 -33 2 8.70488 5.4763 3.16894 -36.9473 -0.666442 -22.4182 -34 1 1.61615 3.95559 11.5848 -7.57046 15.5603 -11.9076 -35 2 1.66987 4.89506 11.8258 -4.51216 0.523906 3.16779 -36 2 2.10845 3.4705 12.2371 10.5178 -10.3797 12.993 -37 1 2.10284 6.89743 8.15957 -0.837321 -0.675751 7.8246 -38 2 2.47895 7.28827 8.96165 1.07034 3.30836 -6.30935 -39 2 2.071 5.95646 8.37348 -2.86121 -4.48577 -0.939591 -40 1 5.32433 4.44486 7.86972 -1.34052 23.2477 3.45796 -41 2 5.46877 3.5107 7.98026 -0.0649778 -19.4924 -5.7669 -42 2 4.70188 4.60713 7.1427 0.919422 -2.43856 3.29815 -43 1 3.32435 2.88678 17.4197 -1.88929 -9.6261 16.8991 -44 2 4.05816 3.29734 16.977 14.1471 9.33662 -16.3951 -45 2 2.86083 3.59453 17.8818 -3.32176 6.96255 1.50629 -46 1 7.47308 5.51417 6.17701 6.20604 7.73103 -29.885 -47 2 7.95124 6.07722 6.78768 5.01174 3.41934 10.0258 -48 2 7.09189 4.79949 6.66958 -7.20601 -9.71089 14.7057 -49 1 9.80158 6.99902 12.0223 -22.5784 -4.24274 -21.2019 -50 2 10.1069 6.1805 11.5916 -0.00510546 9.67372 7.70676 -51 2 9.03411 7.28611 11.4542 20.6129 -4.31213 14.2424 -52 1 14.1091 3.78361 8.12438 -15.7573 21.5912 -11.6445 -53 2 13.5201 4.50308 7.77049 18.8532 -19.0333 8.38218 -54 2 14.3457 4.04736 9.022 0.199067 1.13361 3.22772 -55 1 4.50215 17.2152 3.88612 2.87802 -1.37968 10.5361 -56 2 5.34021 17.6676 3.86593 13.8498 1.95887 5.68097 -57 2 3.97594 17.6789 3.24294 -11.45 0.485265 -14.6478 -58 1 16.2741 16.534 10.4726 -5.67102 -12.8311 -21.8814 -59 2 15.486 16.5615 11.0293 -1.33881 1.5325 0.205711 -60 2 15.9943 16.0074 9.67798 5.00326 13.1852 19.554 -61 1 1.98121 4.83276 0.125548 -2.90665 -21.863 0.561723 -62 2 2.62989 5.11603 0.769738 5.61812 10.8419 9.00632 -63 2 1.75087 5.59897 18.2498 0.950825 13.4626 -6.91806 -64 1 11.2654 13.2951 16.4195 -4.34554 -2.68737 -1.67212 -65 2 10.7681 12.4683 16.4833 0.87563 -1.05494 5.85319 -66 2 11.8765 13.1105 15.7039 6.19214 3.55339 -6.25188 -67 1 10.1028 10.9035 16.8331 17.2825 8.49241 1.71185 -68 2 10.5205 10.0327 16.7798 -0.767632 10.3686 4.9905 -69 2 9.17724 10.7556 16.7424 -24.4211 -4.37906 -2.41009 -70 1 11.8507 17.4827 13.4696 7.63981 7.03239 -1.88788 -71 2 12.509 16.94 12.9947 -8.02315 8.08552 1.57387 -72 2 12.1795 18.4053 13.408 -3.08283 -9.25718 -0.840972 -73 1 6.44601 9.4433 12.2773 8.37995 -15.986 -34.1351 -74 2 7.00514 9.1357 11.5138 -12.9725 10.8563 23.5312 -75 2 7.03346 9.94503 12.8365 5.04668 8.97956 7.26084 -76 1 16.2979 12.8575 2.71922 -11.7369 16.949 2.19382 -77 2 17.1652 13.221 2.45954 -10.8006 -1.31331 4.0939 -78 2 15.6758 13.6404 2.78783 18.0783 -23.2667 -2.52892 -79 1 0.707968 12.7192 5.87585 -9.46746 -3.17244 -7.34712 -80 2 1.05314 12.7932 4.98248 12.8843 -1.39545 -4.60697 -81 2 18.4375 12.4692 5.68303 -3.12969 3.97578 10.4064 -82 1 5.29671 16.347 18.4316 -9.43352 6.10902 0.949816 -83 2 5.62099 15.5668 17.9615 5.22561 3.70018 3.69326 -84 2 5.92538 16.5961 0.477291 0.486221 -4.47534 -1.04063 -85 1 0.707184 7.70367 4.119 -51.5024 -35.8612 26.1825 -86 2 0.14378 7.97362 3.40377 -12.5647 4.97441 -12.5535 -87 2 1.50957 8.08535 3.91273 65.7491 26.1316 -14.6887 -88 1 3.20348 9.03456 6.50534 -36.9666 27.611 -24.7826 -89 2 3.63112 8.56754 7.174 27.0077 -25.2244 35.3222 -90 2 2.25579 8.96355 6.72902 9.17057 2.1904 -6.46933 -91 1 7.27937 10.3761 16.2413 -0.230914 -4.48303 6.76598 -92 2 6.52755 10.9587 16.1419 -2.56448 5.11938 -3.06937 -93 2 7.11485 9.96393 17.0986 -0.495486 0.80288 1.59662 -94 1 11.0332 0.910989 5.0177 -6.88619 -3.17881 -8.23488 -95 2 10.972 1.75479 4.54866 7.92386 3.49104 7.17877 -96 2 10.6826 0.325395 4.32946 5.79259 -4.26916 6.55693 -97 1 4.2654 2.89302 13.1773 0.694211 20.6748 -2.64105 -98 2 4.39238 3.45448 13.9576 1.0821 -9.7456 0.782255 -99 2 4.16489 1.98946 13.4871 -0.702651 -10.6992 3.24412 -100 1 8.43419 10.272 1.79599 3.30535 -21.7188 -14.6566 -101 2 8.19585 10.8779 2.48837 0.0509316 11.2873 19.613 -102 2 8.53541 9.39344 2.20281 2.46081 9.96427 2.84146 -103 1 10.2486 1.68186 15.4597 -14.9494 5.38019 -3.47887 -104 2 11.0964 1.37036 15.7536 17.388 -0.916576 -1.92962 -105 2 10.2694 1.89097 14.5087 2.57313 -1.10767 6.05091 -106 1 2.6143 12.7739 7.92246 0.947228 -0.997667 -1.9326 -107 2 3.16975 13.4683 7.54148 -0.729705 2.73148 -0.490338 -108 2 1.96608 12.5591 7.23618 1.36975 0.244975 0.56737 -109 1 3.86268 11.7535 5.00307 -14.4028 -3.16999 8.33757 -110 2 3.70976 11.1475 5.74815 1.12966 3.67823 -8.44516 -111 2 3.06255 11.7297 4.44022 7.7842 4.67892 9.37694 -112 1 6.76061 14.5167 16.9537 -0.888094 -7.58336 -2.84579 -113 2 7.48488 15.1306 17.0914 4.64858 -1.1877 -1.93173 -114 2 6.56705 14.5225 16.0035 -2.02875 6.77169 3.29706 -115 1 14.2034 14.5245 3.20058 -0.0398844 -12.3077 5.38397 -116 2 13.8793 15.4221 3.34301 -5.62621 -2.27359 -1.58508 -117 2 13.7959 13.9448 3.87781 2.42748 11.415 -6.18352 -118 1 8.70505 18.0887 16.0942 -64.5065 -8.09898 -3.91687 -119 2 9.21396 17.4083 16.5058 25.0639 -11.349 2.42178 -120 2 9.16407 0.206988 15.7928 30.835 22.2192 -2.21878 -121 1 4.63692 1.68417 4.88655 37.1566 -9.63698 -3.58798 -122 2 3.87701 2.22405 4.82391 -30.2785 19.7734 3.84799 -123 2 5.28246 2.1077 4.29595 -5.87377 -5.36693 3.35208 -124 1 15.0131 12.6297 16.4887 -20.293 3.22713 36.7225 -125 2 14.5244 12.6173 17.3484 21.3151 5.53737 -15.2497 -126 2 14.2857 12.586 15.869 -0.208138 -0.973548 -24.0506 -127 1 15.729 18.4304 16.8576 -8.95075 23.4819 -17.3869 -128 2 16.2245 18.5231 17.6612 15.7889 -2.20706 14.0604 -129 2 15.4698 17.5226 16.786 -7.06215 -23.0828 1.02158 -130 1 1.394 1.31209 16.6703 -16.8241 -3.16738 2.04331 -131 2 2.15084 1.87826 16.8449 0.715689 -4.34048 -2.49358 -132 2 0.715561 1.66179 17.2756 6.00571 -5.18273 -5.07353 -133 1 18.2252 4.3402 15.9772 -8.55569 -2.73 -13.6324 -134 2 17.823 3.76125 15.3072 5.10239 5.23383 8.49054 -135 2 0.492866 4.4785 15.7127 2.39871 -0.864238 1.29175 -136 1 12.1265 17.032 16.1255 -25.5416 -7.58495 15.967 -137 2 11.3669 16.5924 16.5691 16.6277 5.86514 -1.80192 -138 2 11.8242 17.0598 15.2127 8.00105 4.8532 -10.0676 -139 1 16.1291 2.68344 18.211 0.375456 -13.3929 15.5569 -140 2 15.6138 3.3874 18.6109 -0.098248 15.4546 -4.83257 -141 2 15.8549 2.61026 17.3068 -10.5356 1.78345 -20.9571 -142 1 6.60182 13.7939 10.068 9.2492 3.65708 4.18485 -143 2 6.57275 13.4224 10.9661 -3.78941 -3.14938 -5.19226 -144 2 6.71396 13.0652 9.44214 -7.17216 -3.95227 2.85982 -145 1 10.1302 18.5571 2.70452 28.7428 2.61674 -1.08827 -146 2 10.6588 0.134354 1.90491 -8.77267 0.774664 16.1596 -147 2 9.28539 18.2699 2.40893 -22.5926 -9.32297 -10.0302 -148 1 3.0625 17.7033 6.15366 -32.6923 -3.28618 14.6113 -149 2 2.13754 17.6931 5.7562 38.9757 -0.864197 5.33283 -150 2 3.7049 17.7316 5.44436 -0.964713 0.371031 -13.1926 -151 1 12.6087 16.7853 7.93012 21.3772 -3.32102 -23.3093 -152 2 11.8409 16.2517 7.71322 -11.0279 -6.8961 6.738 -153 2 12.4183 17.3739 8.65053 -14.1479 13.0972 16.1976 -154 1 14.9031 15.2939 8.2802 -30.4011 23.5185 11.3145 -155 2 14.1656 15.9721 8.20757 23.4522 -23.8051 0.0341398 -156 2 15.3634 15.3182 7.4362 3.9964 4.48103 -1.46252 -157 1 17.8706 18.2596 0.245663 2.0948 -17.0514 -11.0411 -158 2 18.6148 17.6985 18.5349 -15.5847 20.6608 16.06 -159 2 18.229 0.448391 0.574358 6.37924 -1.254 -0.87753 -160 1 0.806491 10.487 1.42673 -7.2326 -9.98023 10.4462 -161 2 -0.00161399 9.98055 1.66044 10.6613 4.25192 -4.69396 -162 2 0.557346 11.1929 0.820979 -4.09494 2.43397 -4.83249 -163 1 1.83456 12.2686 3.29043 -8.34448 2.57963 -8.45001 -164 2 1.36787 11.5875 2.7525 13.033 10.6511 2.37549 -165 2 2.15971 12.967 2.6794 -8.27007 -10.3927 7.15994 -166 1 0.688934 17.2807 4.96532 -1.28513 13.5074 -14.6034 -167 2 -0.0176841 17.9487 5.11769 8.40666 -17.1979 3.35047 -168 2 0.596617 16.4414 5.43231 -12.6974 4.79178 9.39957 -169 1 1.09014 0.907525 9.3383 6.29421 1.3921 30.3575 -170 2 1.25758 0.656293 10.2983 -10.9635 5.07818 -25.2558 -171 2 0.281108 0.475301 9.05696 -4.67463 -4.0945 4.23309 -172 1 16.7684 2.39691 13.3495 9.61769 42.5491 2.72371 -173 2 16.904 2.78957 12.4595 -0.731435 -13.0756 10.2936 -174 2 16.527 1.48948 13.2642 -5.98641 -27.7824 -4.48506 -175 1 2.71373 15.9459 12.053 -3.75115 0.267025 20.4445 -176 2 2.98439 15.5717 12.9162 -2.14108 4.62523 -16.3505 -177 2 3.30112 15.6057 11.3695 4.80572 -2.00813 -1.58569 -178 1 16.3912 15.5658 6.1364 -18.5193 -23.7813 -1.39285 -179 2 17.3153 15.4712 6.31079 23.2449 0.130836 8.54259 -180 2 16.3263 16.278 5.5153 -3.20698 17.7917 -15.4301 -181 1 5.73039 5.21537 11.7967 -2.24013 5.33831 8.85226 -182 2 5.58704 6.03693 12.3192 -1.36073 -15.5687 -10.3459 -183 2 5.0707 4.59019 12.1393 4.45693 0.898588 -6.68224 -184 1 15.134 4.90094 0.781902 20.2218 -12.3751 4.08616 -185 2 14.9115 4.68422 1.69179 -1.28767 -2.72314 10.4735 -186 2 14.3889 5.35469 0.437757 -23.5901 14.4279 -10.7703 -187 1 16.3592 16.4594 1.89384 25.1746 19.6936 -18.9686 -188 2 16.2469 16.8 2.79117 -6.86302 3.67352 0.481682 -189 2 16.829 17.1783 1.36994 -16.7874 -21.2348 17.437 -190 1 0.175681 4.85349 3.94905 -38.6563 1.2533 -4.07114 -191 2 0.373462 5.78529 3.89581 11.5619 13.3417 2.94095 -192 2 0.969717 4.36237 4.02266 30.2668 -11.0427 7.4994 -193 1 2.99204 15.0813 15.1763 -0.305205 14.4793 -34.7595 -194 2 2.88713 14.6595 16.0135 -9.94348 -6.29569 26.5741 -195 2 2.4481 15.8945 15.1967 6.07768 -3.34342 6.9782 -196 1 1.12287 14.6661 9.5226 42.1359 23.511 16.8308 -197 2 2.04871 14.8527 9.88052 -40.3465 -4.39318 -17.9218 -198 2 1.08708 13.7187 9.50981 -4.88478 -15.9854 1.2011 -199 1 13.5299 16.5144 11.5405 11.2356 18.9117 4.33104 -200 2 13.1159 17.2557 11.0661 2.81218 -0.6798 2.92705 -201 2 13.1037 15.7572 11.1579 -10.8238 -16.1215 -4.14744 -202 1 4.70977 1.52963 0.718559 3.58248 -24.4192 11.8527 -203 2 4.08939 1.89433 0.0933404 -5.33693 14.3563 -9.66083 -204 2 4.20955 0.796838 1.1277 3.32575 8.01941 1.68952 -205 1 1.50238 18.6141 11.9042 -1.38031 13.5472 16.8753 -206 2 1.45658 0.425239 12.7856 -0.241625 -6.75063 -24.7438 -207 2 2.14944 17.9089 11.9973 -1.06457 -6.06855 3.15913 -208 1 11.4462 10.1354 4.10554 -27.8103 0.519562 13.0103 -209 2 11.5399 10.6236 3.29381 1.04561 4.25273 -17.1067 -210 2 12.3232 9.96387 4.39943 30.3669 -4.33072 3.08727 -211 1 8.16113 12.1728 3.80004 4.97071 -3.14572 14.2587 -212 2 8.9952 12.5305 4.11747 11.4774 1.91239 -11.4095 -213 2 7.64202 12.24 4.61417 -11.8418 -2.63078 -6.07404 -214 1 14.5844 4.03291 3.36716 -4.11232 -3.55002 -24.3582 -215 2 15.2517 4.33672 3.97304 10.7234 0.0718586 14.5399 -216 2 13.7453 4.32617 3.71649 -8.9869 4.72015 4.68372 -217 1 5.72064 1.64489 7.5839 32.9059 28.6425 0.0988457 -218 2 5.06921 1.12259 7.98588 -34.2591 -28.2453 24.4599 -219 2 5.39575 1.74393 6.6993 -3.28926 -2.3453 -25.2911 -220 1 17.8815 1.07824 4.83341 -4.77439 -8.44394 -0.469265 -221 2 18.4195 1.29399 4.06103 3.32925 4.9906 2.38586 -222 2 18.1973 1.60106 5.58304 1.56226 2.04575 -0.708791 -223 1 6.854 9.3046 4.53528 10.3956 -9.62802 3.27507 -224 2 6.69426 9.36632 5.492 2.76918 3.19153 -6.51095 -225 2 7.80605 9.0738 4.45229 -13.5827 1.70924 -0.808399 -226 1 2.59539 14.8276 2.04954 -21.4179 -5.20739 -34.911 -227 2 3.34516 14.7063 2.60932 22.2061 -1.352 15.1427 -228 2 2.90646 14.7931 1.11821 -3.29515 2.22824 22.2692 -229 1 17.3057 12.9587 13.1574 -14.3584 11.8265 -1.68619 -230 2 16.4238 13.3017 13.4505 21.6076 -1.54195 -11.2195 -231 2 17.8123 13.7306 12.814 -13.7958 -9.76612 7.37248 -232 1 14.8715 10.5568 1.52593 -13.8049 33.9422 19.399 -233 2 15.3968 11.3309 1.89043 -12.48 -24.7346 -11.1652 -234 2 13.9264 10.776 1.72699 26.333 -7.21409 -8.066 -235 1 5.65075 6.69227 4.53589 -1.16643 0.470211 -4.08107 -236 2 5.90168 7.60385 4.33311 1.92457 3.57872 5.04239 -237 2 6.31691 6.35225 5.15026 1.24698 1.28263 2.78678 -238 1 8.00933 8.29789 10.2803 -8.03608 2.46456 2.45807 -239 2 8.54459 8.86115 9.67988 -10.051 -7.82575 5.32423 -240 2 7.18397 7.98917 9.84875 17.8376 0.213066 -8.74409 -241 1 13.4452 18.4811 5.71348 30.3006 1.0471 -14.1486 -242 2 12.642 0.299737 5.48582 -19.0854 8.92614 -0.688815 -243 2 13.1967 17.7426 6.25238 -10.7462 -10.7439 19.4962 -244 1 -0.0119027 2.59488 0.354931 35.8038 -39.8932 13.3955 -245 2 17.7273 2.51611 0.10594 -24.5443 11.4005 -8.19311 -246 2 0.27212 3.48779 0.285479 3.99253 30.2779 -6.4317 -247 1 12.849 10.869 9.75158 -6.21929 20.5855 -7.88953 -248 2 11.8713 10.9784 9.78619 15.6811 -13.8069 -0.457669 -249 2 13.0615 9.92753 9.83861 -13.7986 2.36182 2.76964 -250 1 0.623186 12.214 11.083 4.78072 12.4497 9.66308 -251 2 18.3291 12.2937 11.2784 -7.07035 -2.86266 -6.1852 -252 2 1.03568 12.566 11.8864 5.16139 -3.44089 -5.05626 -253 1 5.24317 7.35288 13.329 16.5645 10.6427 9.86574 -254 2 5.81232 8.06371 12.9598 -16.2044 -6.02954 3.80806 -255 2 5.63373 7.21351 14.2126 -3.74153 -4.80134 -10.81 -256 1 1.17457 6.8033 11.9036 -23.8679 10.4664 -9.71638 -257 2 0.289623 7.06715 11.5324 26.398 -8.64759 11.7652 -258 2 1.56564 7.61974 12.2537 0.753648 -2.9175 -1.70229 -259 1 15.4919 9.76734 12.3795 0.0614124 -7.36309 3.05776 -260 2 15.0846 10.6319 12.2391 7.36463 -2.83561 -3.47144 -261 2 15.8873 9.82027 13.2467 -0.105969 -0.524429 6.2821 -262 1 16.5022 12.5635 5.51418 5.92626 -4.93161 -13.1981 -263 2 16.3002 13.4761 5.69188 -2.75562 16.3616 9.80459 -264 2 16.3759 12.5305 4.55079 1.66896 -8.7704 1.12914 -265 1 6.31756 9.85145 0.122373 -12.0354 8.37982 6.54531 -266 2 5.4699 10.2439 0.423151 12.3884 -4.45977 -3.2374 -267 2 6.98984 10.1338 0.758446 2.49067 2.04662 0.271789 -268 1 12.1918 6.08954 4.01066 -16.388 -25.9861 2.6766 -269 2 12.1912 6.72626 3.29268 0.559249 7.6643 3.09763 -270 2 11.3251 5.63233 3.94387 14.2823 13.1494 2.08097 -271 1 0.332379 12.8663 0.0441745 0.0508304 2.00456 8.93046 -272 2 18.9019 13.5185 0.756349 -7.27218 -2.99587 0.981784 -273 2 18.3327 13.1573 18.0278 2.80865 -1.79272 -4.8195 -274 1 3.54313 0.0443203 8.66238 11.9606 -6.13667 -3.48184 -275 2 3.32458 18.1774 7.87344 8.237 1.02812 -5.83338 -276 2 2.68777 0.391851 8.89446 -8.31408 9.03305 4.42594 -277 1 7.44404 17.5122 4.49167 0.119683 3.6114 3.91179 -278 2 7.85567 18.3869 4.65486 -14.0238 -13.6963 -7.23825 -279 2 7.39901 17.3877 3.53399 5.58618 2.96743 1.37553 -280 1 9.26713 17.153 12.2094 -20.2295 17.8608 7.81194 -281 2 9.28392 16.3133 11.7674 1.3049 -15.888 -12.5165 -282 2 10.076 17.208 12.7094 15.0452 0.291548 7.10451 -283 1 13.4068 13.0832 7.92217 -6.10698 -2.73533 15.5952 -284 2 13.4694 12.4257 8.66119 -0.459118 13.24 -15.7611 -285 2 13.8946 13.8972 8.17425 4.86633 -17.7849 -1.17812 -286 1 14.7977 2.95386 15.4326 21.7471 11.1646 11.1554 -287 2 14.1505 2.32893 15.1446 -13.9872 -17.9607 -8.38755 -288 2 15.4352 3.02911 14.7173 3.23846 -4.77681 -7.04868 -289 1 9.91022 15.6467 16.9338 -7.88269 11.4297 -3.43074 -290 2 10.0979 14.7902 16.532 6.40878 -6.10819 3.84543 -291 2 9.43747 15.4751 17.7557 1.6004 -7.26983 6.6271 -292 1 11.2148 8.51865 16.6243 -9.14606 -19.2231 -14.9185 -293 2 10.4285 8.06123 16.2547 13.8022 0.848227 5.21642 -294 2 11.6642 7.88268 17.1928 -1.33785 -0.880144 3.29074 -295 1 3.96477 18.2022 16.8388 0.151724 27.8243 14.0652 -296 2 4.47646 17.6367 17.4198 3.54357 -14.0579 0.0762873 -297 2 4.08749 0.446059 17.2373 -6.51294 -16.617 -15.0442 -298 1 2.23636 4.23466 8.90617 11.6474 4.96614 0.176633 -299 2 3.18727 4.06881 8.84702 -5.0902 0.586039 -2.82984 -300 2 2.03755 4.18072 9.84669 -2.61694 -5.47133 1.10155 -301 1 9.89683 10.3797 9.78633 12.6385 -21.4053 -24.2531 -302 2 9.49137 11.1552 9.42946 -10.1833 20.5571 -3.63947 -303 2 9.86232 10.3926 10.7266 0.554165 3.61624 28.8421 -304 1 9.72109 0.91625 10.832 13.6195 9.02414 1.59857 -305 2 9.21789 0.206273 11.2536 -3.38139 -4.49977 -6.76529 -306 2 9.17946 1.37162 10.1615 -3.40595 -8.11879 6.74876 -307 1 9.15707 15.1255 10.1914 20.6551 -3.22149 9.33909 -308 2 9.01609 15.916 9.68312 -8.41387 13.877 -8.61246 -309 2 8.34011 14.6408 10.1195 -14.233 -7.19689 -0.719266 -310 1 0.808146 9.70808 10.2086 23.84 -38.9856 -20.0319 -311 2 0.930598 10.6496 10.3444 5.65872 6.03362 4.8682 -312 2 1.64643 9.29884 9.83207 -32.5144 23.6532 16.8406 -313 1 17.0698 4.80337 8.05752 27.8638 -35.1931 -3.66362 -314 2 16.2966 5.30586 8.21629 -27.2809 18.9512 9.97555 -315 2 16.9993 3.9693 8.55928 -0.62818 15.8913 -5.61459 -316 1 14.8223 14.6574 0.153467 -11.4546 -14.4551 -9.90243 -317 2 15.436 15.0274 0.766448 14.8773 15.1477 17.5942 -318 2 14.121 14.2916 0.705806 -3.92817 0.026116 -2.07816 -319 1 3.85634 11.0156 9.57857 3.75671 2.20251 0.903354 -320 2 3.89754 11.3203 10.4983 -5.37308 2.01291 2.42961 -321 2 3.35837 11.6719 9.06911 -6.8083 1.73507 0.204751 -322 1 11.3728 10.7464 1.42992 33.2497 -4.81825 9.44885 -323 2 11.5281 11.6383 1.10055 0.915848 5.55374 -4.33141 -324 2 10.4426 10.6155 1.47257 -31.1398 -0.627116 -5.41705 -325 1 13.1828 7.20447 12.6676 -0.0478479 -14.2604 -0.4669 -326 2 14.1298 6.99811 12.5505 -7.76827 -0.67018 4.43892 -327 2 12.735 6.32848 12.7534 7.45412 15.7346 -2.47341 -328 1 9.63194 1.91441 0.890304 3.16134 4.31897 -8.70512 -329 2 8.77158 1.63222 0.526893 10.8452 7.48256 0.350857 -330 2 10.2032 2.19638 0.151243 -8.90992 -2.48069 6.74103 -331 1 10.6318 13.4626 4.55882 -11.5056 -1.99047 12.5083 -332 2 11.4876 13.0509 4.71851 7.47615 -1.29416 -2.63952 -333 2 10.4232 13.8662 5.41293 0.691023 4.41994 -1.81408 -334 1 14.5517 1.66181 10.9802 -11.5576 12.9 9.45395 -335 2 15.3776 1.3055 10.6442 8.04202 2.4344 -3.19562 -336 2 14.6907 2.6148 11.169 4.38713 -8.31284 -15.1855 -337 1 14.4901 12.0498 11.5809 -31.454 -4.77499 25.6083 -338 2 15.091 12.4736 11.0015 28.7023 12.1919 -21.8177 -339 2 13.8321 11.6274 11.0162 -1.74489 3.16984 -4.97875 -340 1 8.17369 5.13537 9.87952 -12.8505 7.96449 12.3464 -341 2 7.30162 5.126 10.3345 14.626 0.500686 -8.94194 -342 2 8.32701 4.24033 9.57061 -3.03583 -8.79147 -1.32617 -343 1 1.61182 16.9829 18.4557 19.3906 15.8485 -25.2691 -344 2 2.09739 17.4464 17.7224 -9.17701 -12.9822 18.3353 -345 2 1.80792 16.0477 18.3234 -0.14796 -4.92565 -1.79656 -346 1 1.43858 17.3769 15.3174 -8.9259 8.94647 7.52005 -347 2 1.45812 18.1702 15.9147 -6.93156 -15.9408 -17.1792 -348 2 0.507347 17.0882 15.1685 14.4449 8.30676 8.33907 -349 1 3.5257 5.78471 6.06613 -3.39677 -13.3058 1.89016 -350 2 2.9753 6.46227 6.46115 -3.38454 1.41808 7.55669 -351 2 4.15739 6.26663 5.53865 9.2569 4.30143 -12.1591 -352 1 12.629 9.51298 14.2604 -9.77978 19.3775 3.35531 -353 2 12.9437 8.76225 13.7938 15.2815 -22.6591 -22.819 -354 2 12.3447 9.10922 15.0729 -6.56341 1.36458 18.6396 -355 1 4.0928 15.2431 7.0497 -2.25109 -22.7738 13.7055 -356 2 3.66448 16.0653 6.81785 -2.80743 13.3283 -7.68 -357 2 5.04695 15.3859 7.01583 3.36741 6.66555 -6.63338 -358 1 0.780201 8.79903 15.0924 -4.1065 -28.223 6.26572 -359 2 0.548696 9.72105 15.1288 -1.34907 18.7642 -4.10325 -360 2 1.5752 8.72345 14.5481 -0.207921 7.22304 -3.82448 -361 1 12.9286 8.29499 10.1476 33.3114 -28.911 32.5654 -362 2 13.7554 7.80683 9.90421 -18.1809 10.2081 -7.43875 -363 2 12.9042 8.10572 11.1188 -9.83308 4.93442 -19.3471 -364 1 15.2998 7.93844 3.50826 -21.0939 -7.00262 -11.8412 -365 2 14.4558 7.58878 3.24395 -11.6977 10.4201 -28.099 -366 2 15.3831 7.3862 4.26257 30.2163 -1.92794 33.2483 -367 1 17.18 6.71526 18.6425 -0.133844 12.8911 -12.7702 -368 2 16.7451 5.93694 0.322596 -6.25651 -15.7248 7.28694 -369 2 16.4413 7.25778 18.3094 9.30548 1.37884 5.01187 -370 1 8.9084 6.99396 7.88573 -0.881002 2.32267 0.0260346 -371 2 9.83584 7.2627 7.79742 -0.0847644 -0.13812 3.11438 -372 2 8.83558 6.46246 8.69404 -0.0294368 0.694249 -1.22754 -373 1 12.437 0.501834 1.22358 -0.716997 -8.58934 -9.29719 -374 2 13.1312 1.05983 1.5788 8.89791 0.478791 5.50433 -375 2 12.732 0.307907 0.326573 -3.73597 1.67796 1.81541 -376 1 5.69458 15.0516 14.5143 3.69591 -14.2553 -4.53333 -377 2 4.76954 15.0969 14.776 -8.31751 1.66253 0.63197 -378 2 5.95328 15.9515 14.3109 5.80865 11.3045 -3.56535 -379 1 3.78081 6.42509 1.75203 4.2348 -8.30075 -4.29513 -380 2 3.33672 7.18396 1.37288 -3.60544 13.0853 -6.67388 -381 2 3.84967 6.63422 2.68491 0.545892 0.795555 6.86444 -382 1 3.88792 11.3989 12.3546 13.0971 -5.24635 -8.64578 -383 2 4.74838 11.8202 12.5261 -6.66532 -1.91753 0.168546 -384 2 3.23677 11.927 12.8169 -5.64663 9.70313 4.55872 -385 1 5.30252 3.85246 15.7701 3.45242 11.6571 4.53522 -386 2 6.06202 3.27771 15.61 2.30678 -4.65184 -5.35711 -387 2 5.68598 4.72788 15.9368 -2.89319 -4.23448 -3.12102 -388 1 14.1378 10.1309 4.62741 -6.40911 2.93718 -21.1253 -389 2 14.285 9.82325 5.50803 7.98673 -9.05047 24.7099 -390 2 14.6717 9.53242 4.07811 -2.84302 6.29722 1.17771 -391 1 7.65634 17.3346 9.10408 10.3132 -24.7491 -1.74792 -392 2 7.07794 17.6856 9.78277 -9.16436 8.21537 0.604828 -393 2 7.96278 18.0151 8.50473 -0.553145 15.1908 -4.94918 -394 1 4.52232 14.5173 3.95827 12.1345 -25.6108 -47.7046 -395 2 4.42958 15.3956 4.25649 -1.76895 36.8878 18.7873 -396 2 4.4098 13.9051 4.66351 -3.8607 -15.3504 25.5968 -397 1 14.1258 7.45828 15.8364 -6.23365 -6.73609 3.75314 -398 2 14.9302 7.39167 15.3277 7.57838 -0.290505 -5.08612 -399 2 14.4287 7.78058 16.69 -2.09073 5.34234 4.78248 -400 1 2.95098 18.3751 1.91859 -29.5535 -1.78839 -16.8987 -401 2 2.45071 17.8858 1.20736 17.1758 4.42604 21.0133 -402 2 2.2449 0.246547 2.36374 11.8246 -5.6794 -7.15496 -403 1 7.99154 1.5773 4.49846 30.6245 -5.45524 3.73918 -404 2 7.42382 1.97686 3.83614 -1.09908 5.00667 -8.45405 -405 2 8.90683 1.55308 4.13454 -22.7919 6.21994 3.05753 -406 1 2.44336 14.1732 17.7263 2.89693 8.8065 2.99283 -407 2 1.80182 13.5359 18.0713 -0.462046 0.279758 -5.24045 -408 2 3.30188 13.814 17.96 10.6791 -8.66055 4.12847 -409 1 0.94217 1.90899 13.8934 13.5408 -1.52741 -1.05885 -410 2 1.19747 1.57322 14.7589 -4.95142 3.16298 5.50662 -411 2 18.6373 2.03702 13.8998 -8.7871 -0.483879 -2.02084 -412 1 4.30938 0.151078 13.8855 7.43827 7.09651 -9.2822 -413 2 5.23906 18.5299 13.9426 -3.76642 -3.92995 -1.86801 -414 2 3.88869 18.4591 14.673 -3.49259 -4.03929 12.0029 -415 1 7.32054 0.93366 18.4163 -33.3446 -10.4004 5.92831 -416 2 7.32153 0.654144 17.4916 5.03052 -1.00997 0.0977128 -417 2 6.36163 0.937686 18.6972 26.0729 9.45288 -6.86634 -418 1 15.8933 18.4156 13.9169 -22.9956 8.12347 -47.8741 -419 2 14.9583 18.5802 13.6337 24.0447 -6.26997 16.1472 -420 2 15.9487 18.2637 14.8423 -3.56821 2.97357 29.888 -421 1 10.2651 4.57121 16.2688 1.93413 -35.0494 -13.7078 -422 2 11.2092 4.46181 16.4883 -7.31309 8.12251 -3.69007 -423 2 10.0229 3.6678 15.9192 2.49448 27.3645 14.4368 -424 1 15.9059 17.707 4.46041 -10.2591 -26.7612 -3.24664 -425 2 16.489 18.4443 4.44561 19.3223 26.1038 4.21423 -426 2 15.1093 18.0276 4.88994 -9.23113 3.77657 -1.20249 -427 1 6.91304 17.5561 13.9404 -32.5423 1.81832 8.8205 -428 2 7.45718 17.7359 14.6891 13.6263 3.56972 27.349 -429 2 7.55119 17.4736 13.2627 22.9256 -5.60471 -32.7019 -430 1 13.1887 6.46821 6.52506 2.14134 -6.99498 -16.9539 -431 2 14.1468 6.55272 6.36688 -10.1834 4.86047 2.66897 -432 2 12.7776 6.33144 5.63446 11.1073 4.86992 20.3892 -433 1 7.86929 2.3014 9.43186 -7.43999 -0.581733 -7.42672 -434 2 7.28758 2.26368 10.206 1.54253 -4.13193 1.23421 -435 2 7.37428 1.85692 8.71867 3.17855 7.90221 2.8646 -436 1 15.2039 14.7441 13.779 -1.62406 2.57688 -1.70285 -437 2 14.9354 14.9492 14.6806 -4.8726 3.09257 3.44485 -438 2 14.7582 15.3762 13.1995 0.661267 -3.02741 1.58802 -439 1 9.4149 8.38535 3.859 -25.1665 -10.991 -5.57318 -440 2 10.2049 8.88585 3.99067 20.2759 12.8236 2.22258 -441 2 9.67249 7.46496 3.96553 -1.56288 -2.67339 -2.00262 -442 1 17.7026 13.5834 16.4242 -1.80346 -11.0476 6.4727 -443 2 16.7549 13.3713 16.3986 -0.662501 7.25922 -2.44544 -444 2 17.8485 14.4294 15.9813 -4.13054 1.45271 -4.35383 -445 1 4.91191 10.5224 2.88074 35.1139 -21.7488 -13.7776 -446 2 5.74832 10.1175 3.20879 -18.1595 7.39309 -6.65206 -447 2 4.64711 11.0636 3.60968 -4.98951 12.9254 11.8317 -448 1 3.70989 8.40692 9.9178 -3.43098 -13.3807 16.77 -449 2 3.72102 9.34916 9.72654 3.49477 5.64054 -2.09668 -450 2 3.74613 8.34545 10.8924 -2.49133 1.09455 -12.0955 -451 1 15.9811 6.93645 5.90716 -9.64967 -5.56515 0.983492 -452 2 16.7246 7.40088 6.29715 7.31355 3.31596 3.21676 -453 2 16.2311 6.00551 5.84179 2.78737 3.87161 -3.53071 -454 1 15.2416 7.2288 8.97537 -25.1477 -13.3308 -14.4253 -455 2 15.9965 7.60799 9.37505 30.1105 10.4166 22.3283 -456 2 15.0439 7.80906 8.23828 -3.19363 1.15625 -6.55237 -457 1 6.20437 12.8345 12.7354 -14.1465 10.1654 -16.7884 -458 2 6.94522 12.3758 13.1101 18.4885 -10.5564 10.7987 -459 2 6.04629 13.6348 13.2503 2.66058 2.52169 8.79246 -460 1 12.1262 4.55048 13.1243 17.0811 13.049 12.1055 -461 2 12.3395 4.65477 14.0809 -9.37635 -6.07885 -14.152 -462 2 11.329 4.03313 13.0256 -8.31182 -5.5816 3.57791 -463 1 11.4354 8.07801 7.94226 -0.810806 3.70784 -8.7596 -464 2 12.2037 7.66847 7.47953 -11.1819 -0.00285319 12.9065 -465 2 11.6202 8.13058 8.89801 9.03316 -1.52538 -12.7532 -466 1 16.9943 10.8342 7.6109 -5.03955 -8.49642 17.9987 -467 2 17.7716 10.3123 7.42961 10.8043 -13.0503 -0.479497 -468 2 16.9113 11.4133 6.86596 -8.14606 13.8231 -19.3584 -469 1 5.21042 18.0585 10.7699 15.6232 7.92267 2.97831 -470 2 4.74775 17.5474 11.4283 -5.6196 -5.04348 5.46467 -471 2 4.57391 18.2408 10.077 -8.01525 -1.2934 -10.8517 -472 1 7.60043 17.4332 1.64042 6.79415 6.05281 -21.827 -473 2 7.93761 16.6332 1.20425 2.91062 0.230192 8.27204 -474 2 7.75711 18.1408 0.980897 -9.32049 -5.6032 10.0359 -475 1 1.93897 12.9382 13.63 3.13689 -3.11692 -16.6768 -476 2 1.43678 12.3217 14.1546 -10.1951 -7.38374 9.42459 -477 2 2.04891 13.7234 14.1672 6.66588 6.79896 5.37665 -478 1 9.3938 6.77683 14.8244 15.3217 -3.43003 -1.39025 -479 2 9.8639 6.00007 15.2423 -8.39432 15.0581 -15.9266 -480 2 9.75443 6.97816 13.9251 -4.83499 -14.7492 16.6004 -481 1 15.2802 4.37234 10.7612 17.1837 -0.598437 7.1821 -482 2 16.2442 4.23454 10.6079 -20.4209 -0.451849 5.19081 -483 2 15.2528 4.98337 11.5249 -0.66536 -5.42981 -12.7574 -484 1 11.4105 6.21551 0.0734026 -8.7314 7.93342 -2.27424 -485 2 11.3895 5.26963 0.0141504 12.2817 -18.3718 -0.889513 -486 2 10.499 6.41528 18.4856 -6.56297 9.87049 -0.998012 -487 1 18.513 11.4235 14.9225 12.9282 -22.681 3.72438 -488 2 17.9895 11.7369 14.1972 -5.90482 9.25399 -19.4183 -489 2 18.3571 12.0937 15.574 -0.537982 14.5307 17.0247 -490 1 7.08328 9.28085 7.30918 -19.7197 4.18214 5.56511 -491 2 6.73297 8.51044 7.78417 1.76821 -0.286333 -7.5509 -492 2 8.01676 9.1548 7.24802 24.3996 -5.081 -1.83944 -493 1 18.3255 15.3437 12.2137 -3.8694 0.735905 0.400418 -494 2 0.599616 15.5 11.9645 6.26195 2.32841 -0.363056 -495 2 17.7995 15.7522 11.5099 -2.40985 0.96637 0.371307 -496 1 16.511 4.37404 5.22763 -21.2214 -5.51878 25.3236 -497 2 16.4647 3.99489 6.12381 2.74309 1.28503 -9.80457 -498 2 17.4303 4.54035 5.0616 22.4703 -0.915278 -13.9933 -499 1 17.7218 3.13981 10.7749 -4.33552 13.9915 6.34554 -500 2 18.6231 3.34836 11.0663 1.21144 -2.68719 -3.11144 -501 2 17.734 2.28626 10.3485 2.99182 -14.4528 -5.38806 -502 1 12.2792 18.655 10.1327 17.2693 -45.8263 -15.1364 -503 2 11.5058 0.449575 10.4425 -26.2107 18.2097 8.79889 -504 2 13.0094 0.611642 10.1232 12.3896 24.8189 4.81349 -505 1 10.4214 9.73086 12.5154 -11.4047 -1.1898 4.78042 -506 2 11.1516 9.87418 13.1364 2.96428 -4.00819 -1.03044 -507 2 10.2474 8.77319 12.4992 9.30457 6.64045 -3.3636 -508 1 0.651598 2.68478 7.18172 -17.9134 21.5061 -11.8097 -509 2 0.347525 3.6016 7.34273 5.69642 -14.867 -2.54197 -510 2 0.849668 2.34638 8.05251 8.91351 -8.30419 8.52406 -511 1 0.318497 15.272 6.90444 -3.43175 -0.902574 -18.2314 -512 2 0.478582 15.5644 7.78858 6.40513 2.68345 23.4663 -513 2 0.623162 14.3599 6.89897 0.272636 -4.92753 -7.69196 -514 1 17.0533 6.94572 15.0273 7.81631 0.565766 -0.894277 -515 2 17.8128 7.55845 14.958 -6.36521 -5.11302 -0.197876 -516 2 17.4132 6.11744 15.3876 -1.58799 4.21551 0.905627 -517 1 9.15046 12.5368 8.00027 -36.358 14.0028 8.44058 -518 2 9.59383 11.9142 7.43445 3.21629 -19.4527 -15.2125 -519 2 8.22229 12.648 7.66907 25.8785 -7.47424 5.38289 -520 1 1.16102 1.67919 2.79298 -14.264 -19.5534 -4.4961 -521 2 1.06769 2.21394 1.99483 -1.93616 3.76767 1.09072 -522 2 1.84572 2.00753 3.35812 13.0572 19.5695 8.60311 -523 1 4.13351 15.1441 9.8761 6.18483 -5.86151 -6.61306 -524 2 3.91524 15.1965 8.93344 2.62784 3.42174 0.908977 -525 2 5.03514 14.7702 9.87632 -7.63961 1.62567 3.94135 -526 1 7.3909 2.2738 14.7748 9.28558 9.05007 -9.33433 -527 2 7.12441 1.5503 14.2057 -1.53405 -3.63662 -1.19206 -528 2 7.87829 2.88836 14.1809 -18.0097 -8.54319 17.0088 -529 1 18.3492 14.5565 2.15246 12.0934 24.362 7.12212 -530 2 0.551729 14.8667 2.53499 -6.69921 -6.84856 -6.85574 -531 2 17.7888 15.364 2.12839 1.3753 -15.6354 -3.85708 -532 1 10.0163 2.6808 12.9164 -0.493731 -5.11601 -9.40492 -533 2 9.92018 2.0572 12.1601 0.76191 10.4011 8.73608 -534 2 9.26265 3.29452 12.869 4.65507 -2.10266 -3.09911 -535 1 2.95427 8.9021 13.1034 24.5728 -3.04867 -5.91166 -536 2 3.51177 9.68096 12.817 -20.8286 -16.9148 9.19061 -537 2 3.59809 8.18481 13.2917 -7.73525 14.463 -2.49767 -538 1 3.26448 8.6069 3.78485 -10.2248 -21.121 34.5648 -539 2 3.76672 9.19042 3.24166 13.0731 20.305 -12.8555 -540 2 3.48359 8.83627 4.72374 -5.93153 -5.30867 -25.3462 -541 1 5.8473 7.24819 8.6208 2.3932 7.90906 9.86277 -542 2 5.81432 6.28497 8.53212 -5.5277 -2.57364 -0.635967 -543 2 5.0659 7.54439 9.12071 1.08185 -7.49096 -4.29671 -544 1 14.8764 1.57981 1.83846 12.2497 10.4795 -14.7641 -545 2 15.1104 2.2908 2.43504 -9.02026 1.90223 13.0204 -546 2 15.3525 1.8445 1.03212 -8.04537 -15.132 5.23431 -547 1 8.61698 15.0264 0.696156 7.89205 -2.64916 2.43147 -548 2 9.41092 14.8348 1.25307 -18.4618 8.30064 -5.38467 -549 2 7.89576 14.464 1.0316 3.03152 0.23278 2.41128 -550 1 15.4513 1.4301 7.20503 6.99627 -6.82188 0.69389 -551 2 14.8244 0.90582 6.69357 -2.8394 0.789398 0.0418873 -552 2 15.0149 2.26607 7.38205 -7.95005 6.31947 4.24803 -553 1 4.96675 12.927 18.445 -0.392058 -1.0762 11.0005 -554 2 5.34886 12.9244 0.695922 -4.30965 1.19363 -4.30526 -555 2 5.68 13.266 17.9034 2.74534 3.65082 -4.88489 -556 1 15.3953 8.66034 18.0902 -2.07624 -16.7815 -3.18775 -557 2 15.9144 9.19311 17.4724 -5.66293 4.97787 2.21077 -558 2 15.1583 9.22886 0.188985 2.48846 7.45062 3.31632 -559 1 12.0359 3.11648 18.28 -8.04977 7.84102 -5.19135 -560 2 12.2901 3.11968 0.565205 5.43673 -10.4163 -2.44039 -561 2 12.4787 2.41139 17.7764 2.20222 0.638625 8.9068 -562 1 13.1884 12.6911 5.14611 -2.25763 -6.31837 -0.123489 -563 2 13.4652 11.7849 4.90596 3.78769 10.9202 3.38983 -564 2 13.3386 12.7839 6.10454 1.74722 -2.69816 -5.37077 -565 1 6.12211 7.19464 0.152335 -0.889801 -16.5081 12.3486 -566 2 6.2475 8.12337 19.0248 -9.08967 1.02729 -5.81202 -567 2 5.35557 6.85974 0.666933 3.80599 9.00251 -10.0268 -568 1 17.6814 15.8746 14.896 -32.95 0.345881 -9.96463 -569 2 16.7135 15.9334 14.9982 15.4899 6.1636 11.5551 -570 2 17.7111 15.6936 13.9484 19.9419 -0.275145 -3.25111 -571 1 13.1284 0.88699 16.7751 -4.95458 6.20661 5.10718 -572 2 14.0638 0.660956 16.7688 7.30918 -0.228866 0.981928 -573 2 12.6898 18.6827 16.6682 -2.70263 -7.7996 -4.366 -574 1 10.8711 14.4993 7.46323 15.7126 -17.3597 -1.2585 -575 2 10.128 14.0173 7.85917 4.58757 6.56369 -3.56814 -576 2 11.6082 13.8461 7.48059 -10.4237 16.2655 0.791757 -577 1 17.6751 8.40087 2.13849 -13.7675 10.6042 3.42109 -578 2 16.7708 8.37025 2.51335 11.2555 0.423493 -3.0905 -579 2 17.6147 7.881 1.33167 1.95975 -7.58305 -2.5048 -580 1 12.424 7.82566 2.03348 6.80204 18.2298 -3.36389 -581 2 12.2928 8.74872 1.74157 -3.31877 -9.32949 5.70746 -582 2 11.9673 7.27395 1.39444 0.405274 -3.29714 -11.9602 -583 1 12.0088 14.6056 10.3972 49.4943 -15.6831 -19.0447 -584 2 12.4654 14.316 9.56616 -19.1829 7.51475 23.0356 -585 2 11.0956 14.6861 10.1978 -35.275 4.57666 -6.07844 -586 1 6.81054 6.90501 15.534 -24.6279 -1.31201 9.93627 -587 2 7.70831 7.14913 15.3109 11.0416 1.99651 0.427612 -588 2 6.48555 7.50951 16.2192 7.91049 -4.43387 -1.91407 -589 1 7.94039 4.47545 13.2332 14.4982 34.8647 21.806 -590 2 7.26408 4.6474 12.5684 -6.44209 3.92223 0.968251 -591 2 8.05746 5.34482 13.7439 -3.25809 -36.365 -21.9094 -592 1 13.3499 12.2014 14.3127 -1.24116 1.37617 13.1465 -593 2 13.3241 11.2332 14.3368 -6.04942 0.470969 -4.28371 -594 2 13.6308 12.4336 13.4212 3.90264 0.498209 -3.09495 -595 1 14.5954 9.45997 7.28998 13.2192 -1.86441 -1.0042 -596 2 15.4197 9.90762 7.5754 -11.2574 0.0534663 -4.99205 -597 2 13.8535 9.8793 7.72336 -3.17401 5.05716 8.17378 -598 1 12.6619 16.8656 3.26711 -0.0867316 -13.7478 -1.21165 -599 2 12.9036 17.3981 4.01825 1.80146 10.547 8.89773 -600 2 12.7645 17.4143 2.493 -0.0316456 12.4477 -7.66427 -601 1 1.00141 7.10091 17.3455 15.3286 -2.27437 -0.63111 -602 2 0.197357 6.73674 17.6796 -23.7065 -4.2556 16.6559 -603 2 0.696205 7.72166 16.6912 7.12828 11.4292 -16.7267 -604 1 12.984 4.84784 15.752 -30.1278 -7.6986 -1.85236 -605 2 13.773 4.32613 15.627 12.1969 -0.534485 4.03194 -606 2 13.2127 5.76882 15.785 16.3015 19.3583 1.60965 -607 1 2.35806 3.40155 5.13736 7.00458 -19.3644 -43.6846 -608 2 1.86996 2.9687 5.81855 -13.4119 -5.52905 24.958 -609 2 2.73401 4.18924 5.49805 8.9837 23.3098 13.0491 -610 1 8.19273 10.9521 13.6844 -8.81681 4.64201 23.2716 -611 2 8.19092 10.7627 14.6526 -0.424045 0.881441 -21.4162 -612 2 8.95149 10.4932 13.3231 15.2004 -1.23984 -4.72202 -613 1 13.0449 1.52469 13.2577 -17.2068 8.30684 11.3152 -614 2 13.5293 1.59874 12.4201 -3.55841 -0.219514 3.90721 -615 2 12.4208 2.28784 13.3343 18.9425 -17.4385 -9.09999 -616 1 6.61166 13.6023 2.12464 -9.14589 11.0627 -26.7302 -617 2 6.03511 14.0379 2.75872 -4.67031 1.02227 7.02539 -618 2 7.1693 13.0213 2.62577 8.97168 -8.12604 14.3361 -619 1 15.8326 6.37868 12.5447 13.0084 18.5244 20.7727 -620 2 16.3675 6.96965 11.9727 -5.6566 -10.5049 5.53461 -621 2 16.1589 6.56267 13.4684 -3.25982 -7.33208 -24.589 -622 1 16.7829 0.679169 9.53725 3.65315 -1.00951 10.2573 -623 2 16.653 18.4141 9.83094 1.34292 -7.75704 2.15353 -624 2 16.269 0.772043 8.73148 -3.87084 4.41009 -12.8197 -625 1 6.12871 11.643 8.2509 28.8456 37.0564 -10.7514 -626 2 5.32101 11.4251 8.67159 -25.2961 -16.2243 16.4685 -627 2 6.59615 10.8374 8.068 1.48557 -20.4229 -4.39625 -628 1 2.81588 8.6455 0.385911 -12.1168 -14.4708 -15.8933 -629 2 2.2408 8.27575 18.315 12.5525 5.70225 18.3425 -630 2 2.25296 9.2478 0.88122 -2.81952 5.7616 1.15354 -631 1 10.1112 10.3249 6.56463 -6.88185 10.2676 4.3595 -632 2 10.6724 9.72741 7.0699 2.3169 -7.24343 0.885556 -633 2 10.4905 10.3984 5.68005 1.7842 -2.70629 0.197339 -634 1 6.85117 15.7741 6.71172 -4.51814 -4.38518 8.0947 -635 2 7.10947 16.276 7.50071 -0.280141 -2.70051 -1.05147 -636 2 7.0022 16.3747 5.97143 2.95927 2.8361 -5.64101 -637 1 6.55245 12.8624 5.85582 3.66478 4.31955 2.99752 -638 2 6.71899 13.7301 6.24424 -0.933807 5.79026 -3.46681 -639 2 6.12481 12.3549 6.55179 0.263982 -0.200358 2.15574 -640 1 16.7435 12.5401 9.7846 -13.9618 -8.21713 16.7649 -641 2 16.8388 11.8663 9.10427 2.99064 0.578166 -4.74348 -642 2 17.1608 13.3339 9.48085 7.01955 11.3182 -8.14386 -643 1 6.27773 2.82725 2.7475 -16.1332 4.52919 -16.5002 -644 2 6.37029 3.76301 2.48637 6.52487 -6.75351 6.59876 -645 2 5.7241 2.45518 2.0296 8.37538 -0.331655 9.00677 -646 1 10.7419 2.97566 3.2545 -3.93098 2.36946 -8.35386 -647 2 10.3631 3.83794 3.45313 -5.44824 -1.84651 0.91029 -648 2 10.2755 2.65841 2.45654 4.06882 -1.04864 5.83378 -ITEM: TIMESTEP -90 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.80968 6.6261 17.8375 -14.5778 0.995444 8.41947 -2 2 7.95772 6.60642 18.3334 15.3437 1.8775 -14.2431 -3 2 8.74654 5.99095 17.1112 1.57504 -1.57025 6.7209 -4 1 0.142832 8.36014 6.73441 10.0116 -15.4349 27.0014 -5 2 0.232649 8.20449 5.79462 4.11725 -7.32768 -11.6468 -6 2 0.67494 7.65251 7.20998 -18.6261 25.5606 -16.1468 -7 1 8.65703 0.380136 6.98192 16.3005 -1.0776 2.50655 -8 2 9.57515 0.309779 6.66722 -10.0942 0.994659 4.05519 -9 2 8.27212 1.03395 6.395 -6.58679 0.322126 -3.42087 -10 1 6.47941 1.69165 11.7468 2.00503 -21.4393 -6.03474 -11 2 5.9725 2.29393 12.2744 -13.1143 10.2157 7.12378 -12 2 5.89376 0.920881 11.5936 7.71629 6.15291 -2.33076 -13 1 6.9103 5.50063 2.38437 -35.7814 23.4203 2.69428 -14 2 6.20944 5.92743 2.96221 29.3961 -15.7919 -7.47581 -15 2 6.73166 5.94071 1.53167 10.6635 -7.16691 8.95661 -16 1 16.211 10.2361 16.1124 -22.7966 -2.93172 13.0323 -17 2 16.937 10.2632 15.5246 28.6916 5.0146 -15.8412 -18 2 15.9737 11.152 16.3021 -3.36115 -0.429235 -4.16748 -19 1 10.8196 14.9788 2.33309 -6.31813 -9.42536 4.48609 -20 2 10.7437 14.525 3.19227 -2.25161 -0.175376 -6.3843 -21 2 11.168 15.8375 2.56675 6.6431 8.63317 3.56201 -22 1 17.1655 8.21466 10.9616 20.3007 -11.9207 -19.649 -23 2 16.6876 8.89778 11.4174 -14.8371 14.2918 8.905 -24 2 17.9353 8.67496 10.5709 -5.82559 -3.7293 4.59063 -25 1 14.5981 15.9748 16.3536 13.4587 -18.0704 19.8012 -26 2 13.6875 16.2688 16.3636 -10.2246 8.72504 -7.33216 -27 2 14.6733 15.4751 17.2031 2.63957 5.2712 -15.5493 -28 1 12.1292 13.2811 0.580093 14.6523 -12.0599 13.1814 -29 2 11.875 13.3883 18.3092 -10.372 6.98394 -12.7652 -30 2 11.639 13.8901 1.1449 -2.74566 6.59249 -3.74219 -31 1 9.34925 5.48981 3.82539 12.3818 -0.191077 28.8485 -32 2 8.80634 5.44704 4.61652 7.17551 -1.92534 15.5524 -33 2 8.65833 5.42982 3.20736 -26.4153 -0.989629 -43.3837 -34 1 1.57757 3.9189 11.5719 -21.368 33.8782 -18.8992 -35 2 1.50486 4.82423 11.9434 2.77 -7.29772 -4.79385 -36 2 1.95891 3.38097 12.2317 20.2106 -22.0339 29.781 -37 1 2.11583 6.92705 8.12278 -10.2704 -2.23476 -15.4196 -38 2 2.47676 7.42607 8.85663 6.65774 -1.70501 8.2798 -39 2 2.06913 5.99576 8.38149 2.03129 -2.32531 8.57063 -40 1 5.2846 4.43559 7.83749 -11.1092 26.0267 -7.92074 -41 2 5.42959 3.50305 7.74019 3.58921 -20.4287 3.63869 -42 2 4.59753 4.67739 7.1831 9.16507 -0.464339 6.41033 -43 1 3.36483 2.87842 17.4354 -5.48754 -0.0293267 11.8999 -44 2 4.0122 3.13798 16.7945 16.5223 13.9802 -16.1706 -45 2 2.91387 3.69111 17.7275 -1.08839 -5.27878 2.29607 -46 1 7.51128 5.54904 6.16479 9.71808 2.6671 3.00483 -47 2 8.12131 6.08033 6.71556 -9.69992 -1.44216 -4.10694 -48 2 7.04033 4.98631 6.78947 -1.48399 -2.17988 -0.0590646 -49 1 9.79239 7.0023 12.0333 -12.7203 -1.67256 -9.54047 -50 2 10.0574 6.1295 11.7028 -2.54946 7.94968 0.438659 -51 2 9.0334 7.28866 11.4661 15.1177 -5.87574 8.09476 -52 1 14.1269 3.84395 8.13857 -24.8841 12.3935 -19.8999 -53 2 13.4363 4.47719 7.80064 24.2741 -16.3277 6.83338 -54 2 14.3749 4.15432 9.00462 4.04893 6.4318 14.0535 -55 1 4.52686 17.2232 3.85531 -7.09571 -9.71268 16.0786 -56 2 5.35353 17.6803 4.02689 3.89364 6.28665 -2.88462 -57 2 3.96567 17.7155 3.24673 4.45666 4.6431 -9.26961 -58 1 16.1958 16.5107 10.5377 18.4287 -13.9772 -31.1199 -59 2 15.4454 16.6557 11.0933 -16.6117 1.05393 13.9092 -60 2 15.8645 15.9242 9.81336 4.55855 15.7974 16.2758 -61 1 1.967 4.85121 0.0645769 9.40837 -19.0171 0.778776 -62 2 2.73793 5.10942 0.56616 3.15966 4.76786 17.0447 -63 2 1.80075 5.61055 18.1709 -12.801 18.3624 -15.2179 -64 1 11.1737 13.314 16.4367 2.74473 1.78814 5.72217 -65 2 10.7128 12.4641 16.5748 8.32361 2.87799 -7.58216 -66 2 11.8417 13.1969 15.7431 -5.18043 -7.14508 -0.417807 -67 1 10.0458 10.8999 16.8205 33.4394 -5.51473 9.19041 -68 2 10.5428 10.0531 16.9406 -15.1708 22.1127 -3.77119 -69 2 9.12902 10.6892 16.7607 -22.7906 -6.8787 -3.44008 -70 1 11.889 17.5084 13.4814 3.48745 6.24304 -13.0003 -71 2 12.5913 17.1622 12.8998 -9.91022 -4.16273 6.93206 -72 2 12.0139 18.4633 13.4204 2.43964 2.21886 2.73389 -73 1 6.44228 9.49569 12.2996 9.71147 -12.8692 -34.1322 -74 2 7.06965 9.17025 11.5988 -17.7592 6.4035 17.1392 -75 2 6.97144 10.0526 12.8659 4.91959 6.23922 4.73193 -76 1 16.3022 12.832 2.75135 -12.5209 9.65366 -4.24277 -77 2 17.1598 13.1655 2.44684 -4.70434 0.462679 5.46936 -78 2 15.6996 13.6248 2.74248 12.9928 -20.5688 3.1232 -79 1 0.706696 12.7395 5.83755 -10.6776 2.47735 15.1944 -80 2 1.02688 12.9731 4.95908 -4.07327 -10.4263 -9.29508 -81 2 18.3891 12.5308 5.80039 14.5368 6.4085 -10.1514 -82 1 5.29875 16.3254 18.4501 12.7507 -5.44046 -6.67673 -83 2 5.72604 15.6129 17.9385 -8.69196 7.59677 5.8406 -84 2 6.01274 16.6418 0.375909 -8.3334 1.51688 4.30584 -85 1 0.743878 7.68205 4.10167 -26.7478 -30.2572 33.4946 -86 2 0.179417 7.92019 3.37827 -7.5716 9.21403 -16.4097 -87 2 1.60385 7.98113 3.89879 36.269 17.899 -12.2731 -88 1 3.22103 9.09598 6.53924 -28.7289 15.6764 -27.4701 -89 2 3.63534 8.61301 7.2251 9.03881 -15.9481 23.3571 -90 2 2.25678 8.88215 6.53178 21.3431 5.76786 5.41461 -91 1 7.2773 10.3926 16.241 -1.60955 -9.9776 11.4431 -92 2 6.63502 11.108 16.2935 -0.090439 -0.440245 3.15105 -93 2 7.09074 9.80627 16.9963 -3.87073 10.8392 -3.46734 -94 1 11.0095 0.891279 5.03438 2.23591 -17.8064 16.3849 -95 2 10.8775 1.7336 4.57918 5.69275 -3.07397 -7.72854 -96 2 10.7003 0.188666 4.43596 -0.931337 13.9517 -3.17827 -97 1 4.21583 2.94335 13.1635 9.62289 2.41259 16.4284 -98 2 4.47922 3.3428 14.0131 -5.18172 -0.255184 -10.0037 -99 2 4.1364 2.00091 13.3783 -2.2119 -1.88246 -4.82143 -100 1 8.45625 10.2801 1.81127 9.01648 -22.0588 9.24648 -101 2 8.30671 10.8697 2.54783 -2.77767 16.2884 7.52121 -102 2 8.66335 9.4444 2.27657 -0.852681 8.00384 -10.6723 -103 1 10.2261 1.659 15.4538 -6.06042 8.31352 -11.6288 -104 2 11.1361 1.48308 15.6359 20.1952 -3.56794 7.64131 -105 2 10.2187 1.98601 14.5369 -5.79366 -2.30068 5.3707 -106 1 2.60435 12.742 7.94637 -6.15341 0.568057 0.983218 -107 2 3.03975 13.5699 7.72118 6.64853 3.0435 -2.79803 -108 2 1.95513 12.6117 7.24141 1.86204 -3.09485 1.26562 -109 1 3.88579 11.7956 5.01149 -19.6155 -13.0634 1.96641 -110 2 3.74363 11.1082 5.69355 0.727972 11.568 -8.07528 -111 2 3.05901 11.8342 4.47209 17.5209 1.69759 11.0979 -112 1 6.76239 14.55 16.9383 -0.403452 -2.75277 4.08609 -113 2 7.61561 14.9826 17.0312 2.52456 -1.29817 -0.221044 -114 2 6.44911 14.7692 16.0549 2.09428 -3.60588 -3.74869 -115 1 14.1942 14.5231 3.16652 -5.12336 -14.4242 4.12891 -116 2 13.6899 15.3256 3.31261 0.149267 9.23779 -5.23449 -117 2 13.7696 13.8761 3.7521 4.09464 2.97302 0.255936 -118 1 8.7401 18.0877 16.1157 -15.0544 -15.1521 5.72203 -119 2 9.42706 17.4939 16.3945 -6.08837 -23.732 7.70311 -120 2 9.27218 0.11536 15.7481 8.35971 40.209 -14.9349 -121 1 4.63391 1.71898 4.89 36.0507 -5.82478 -13.0459 -122 2 3.81997 2.19927 4.85319 -16.3674 13.8452 0.00946397 -123 2 5.20292 2.04685 4.14723 -16.8402 -3.94878 19.5369 -124 1 15.0105 12.65 16.5031 22.0082 2.89039 39.0948 -125 2 14.6032 12.5883 17.4132 0.919275 4.87615 -33.2046 -126 2 14.3966 12.5461 15.7793 -22.8851 -3.84554 -8.75239 -127 1 15.7197 18.424 16.8504 13.0838 27.0964 8.25258 -128 2 16.3964 18.519 17.5419 -1.36847 2.51381 -4.544 -129 2 15.6686 17.4972 16.714 -13.5977 -31.6712 -2.03374 -130 1 1.39308 1.32386 16.6798 -9.07755 4.26299 3.83254 -131 2 2.19455 1.8573 16.8358 -13.1892 -10.0845 0.867767 -132 2 0.760663 1.62622 17.366 11.6728 -4.82483 -8.86289 -133 1 18.2416 4.3099 15.966 -4.36834 -5.16176 -14.6355 -134 2 17.7783 3.61219 15.465 8.57404 10.6893 6.25867 -135 2 0.425079 4.50442 15.5034 -5.04787 -4.14191 4.79432 -136 1 12.0688 17.0582 16.1192 -6.60497 -5.44285 54.7429 -137 2 11.374 16.6436 16.7154 18.2098 8.22439 -32.524 -138 2 11.7541 17.1189 15.223 -7.97888 -4.44492 -17.7493 -139 1 16.0987 2.72798 18.2222 -6.94033 2.52412 -3.34156 -140 2 15.6657 3.49187 18.6187 5.88163 2.98889 4.51464 -141 2 15.8079 2.8031 17.3159 -2.77048 -8.0731 -14.4365 -142 1 6.58612 13.762 10.0351 1.63352 -0.32404 13.73 -143 2 6.39624 13.3299 10.8846 2.34483 4.77487 -0.634471 -144 2 6.55421 13.0562 9.39028 1.369 -6.64332 -8.7831 -145 1 10.1169 18.5721 2.70869 27.9004 -1.02691 -4.20355 -146 2 10.7561 0.140951 1.98734 -15.1054 -0.137902 13.7961 -147 2 9.28626 18.3596 2.30468 -14.2521 -4.05351 -7.65243 -148 1 3.07988 17.6804 6.1902 -35.1734 2.13391 -17.3705 -149 2 2.15682 17.7525 5.8242 24.0448 -4.32039 20.662 -150 2 3.55195 17.7661 5.36197 20.4585 -2.58277 -0.69289 -151 1 12.6061 16.7775 7.89366 1.16584 -8.73771 -17.6522 -152 2 11.856 16.1922 7.7211 -0.763759 -4.24653 -1.89641 -153 2 12.3057 17.3353 8.59898 -2.13454 17.8975 18.5826 -154 1 14.8965 15.3132 8.35277 -22.4274 15.9599 0.214205 -155 2 14.2421 15.9941 8.02515 16.4945 -20.4059 13.6979 -156 2 15.4898 15.1572 7.61828 5.37632 7.31151 -11.1374 -157 1 17.8957 18.2766 0.201476 9.69326 -17.5267 -0.973127 -158 2 18.6995 17.7195 18.781 -12.0492 3.04369 -7.3597 -159 2 18.2321 0.401263 0.645934 -1.5685 17.2308 6.22008 -160 1 0.802158 10.4818 1.45184 -19.0828 -29.4994 30.4216 -161 2 -0.0309651 10.0246 1.77565 29.2477 9.1244 -14.7118 -162 2 0.53478 11.1455 0.834437 -7.87366 18.9841 -18.3051 -163 1 1.85308 12.2863 3.27351 -7.97315 5.10175 -10.2215 -164 2 1.42551 11.5849 2.74616 7.16023 4.54594 2.45335 -165 2 2.09673 12.9814 2.63054 -3.38314 -5.43944 9.55244 -166 1 0.718881 17.2977 4.9616 -19.2906 6.0419 1.76293 -167 2 -0.10575 17.7685 5.12875 8.39755 13.2462 -10.2288 -168 2 0.622971 16.5645 5.55208 6.7728 -21.2776 10.1703 -169 1 1.03867 0.919889 9.35844 3.74022 -6.32288 33.4729 -170 2 1.10918 0.592533 10.3007 6.31379 11.0803 -22.721 -171 2 0.269914 0.464458 9.03134 -8.6906 -2.38217 -7.04515 -172 1 16.7862 2.42581 13.3986 14.7457 27.0937 -15.311 -173 2 16.9847 2.74906 12.4891 -5.29709 -2.40963 18.2684 -174 2 16.5429 1.52129 13.2791 -8.06021 -27.7395 3.47759 -175 1 2.69738 16.0066 12.0777 13.1506 -14.7233 12.6976 -176 2 3.02715 15.5922 12.9029 -9.51867 9.47826 -13.4594 -177 2 3.28974 15.6737 11.3809 -2.31502 2.53439 -1.78657 -178 1 16.3754 15.4917 6.11201 -7.25585 -20.1131 3.67265 -179 2 17.3156 15.5044 6.29369 9.86882 2.22778 5.36532 -180 2 16.2073 16.2228 5.51797 -0.959992 10.1027 -9.31738 -181 1 5.7174 5.24337 11.7813 4.42707 -14.1004 -1.48072 -182 2 5.44277 5.99707 12.328 1.64183 -4.11158 -2.88134 -183 2 5.22325 4.47043 12.1002 -4.92771 7.03451 -4.06757 -184 1 15.1242 4.92712 0.766674 18.5408 -12.9138 10.3204 -185 2 14.9855 4.62556 1.67944 -3.08744 4.9541 4.0864 -186 2 14.3291 5.35182 0.492873 -21.4444 10.4963 -5.72763 -187 1 16.3798 16.4926 1.83048 25.9496 20.3657 -34.7081 -188 2 16.3432 16.8093 2.72897 -9.33108 7.61853 14.7037 -189 2 16.7914 17.2408 1.28765 -16.0156 -28.1785 20.3541 -190 1 0.157471 4.87182 3.99278 -9.81132 22.7056 -3.03191 -191 2 0.5332 5.76253 4.03054 -8.2904 5.08609 0.673103 -192 2 0.911036 4.31937 4.01308 22.6258 -22.4944 4.73784 -193 1 2.97603 15.0857 15.1688 -3.76699 16.0764 -9.28303 -194 2 2.87698 14.8354 16.0845 -1.20729 -14.2266 12.1787 -195 2 2.48786 15.9266 15.1702 1.40562 1.39337 -6.33902 -196 1 1.10637 14.6846 9.51596 31.8836 22.2572 14.4694 -197 2 2.01065 14.9183 9.89233 -34.4229 -12.9306 -18.6629 -198 2 1.03031 13.7317 9.56194 1.94445 -7.79278 4.16037 -199 1 13.55 16.5172 11.5597 10.1041 14.0808 -3.72584 -200 2 13.3442 17.2549 10.9555 -5.19335 -6.01443 7.16005 -201 2 13.1025 15.7566 11.183 -9.96101 -8.306 -1.961 -202 1 4.75563 1.55237 0.702796 10.3802 -26.0161 11.0265 -203 2 4.32304 2.05314 0.014379 -14.7339 5.42124 -2.63334 -204 2 4.14265 0.839056 1.00315 4.15161 14.819 -1.07901 -205 1 1.52656 18.6416 11.9009 -8.95117 16.8483 13.4998 -206 2 1.43825 0.48402 12.7573 3.56637 -8.71242 -18.201 -207 2 1.98334 17.8196 12.0914 3.68072 -6.34965 2.55122 -208 1 11.4393 10.1383 4.17836 -13.7636 4.05009 -8.78245 -209 2 11.3903 10.5027 3.28707 -1.50281 2.58284 -2.63304 -210 2 12.3655 9.96172 4.28712 17.4192 -2.53267 8.67839 -211 1 8.18359 12.1636 3.86104 -21.222 -14.272 -14.5003 -212 2 9.05859 12.5239 4.0446 -0.40723 6.23371 14.3883 -213 2 7.56046 12.2135 4.62832 23.1203 4.46306 -6.77507 -214 1 14.593 4.04535 3.38111 7.28555 -5.40785 -19.1504 -215 2 15.2127 4.15408 4.10794 5.52844 2.67895 3.03112 -216 2 13.7536 4.35259 3.70606 -13.9578 6.65801 6.31365 -217 1 5.72323 1.65443 7.61073 34.4 15.7962 37.2038 -218 2 5.13785 1.03104 8.01585 -19.7408 -11.9782 7.15973 -219 2 5.42676 1.78462 6.74294 -17.7695 -4.7826 -52.6001 -220 1 17.8873 1.06414 4.83181 6.8154 -0.232455 -4.71432 -221 2 18.4369 1.21178 4.04718 -2.79964 -1.76243 2.38037 -222 2 18.3376 1.55744 5.53048 -5.83965 -0.882229 4.9581 -223 1 6.85055 9.23648 4.54341 6.32277 -8.10519 -4.82585 -224 2 6.75809 9.38079 5.49182 3.88959 4.29486 1.07151 -225 2 7.79379 9.02149 4.39148 -10.7358 1.98669 4.12637 -226 1 2.55801 14.782 2.06648 -8.35029 -12.2797 -25.7867 -227 2 3.24533 14.7191 2.71695 15.3489 0.778658 13.055 -228 2 2.98421 14.5338 1.22242 -9.03529 10.4097 12.3511 -229 1 17.2667 12.9721 13.1114 -20.9369 36.2303 -2.57416 -230 2 16.4188 13.4451 13.3365 18.5804 -22.1292 -0.415694 -231 2 17.7749 13.7311 12.7641 -0.529191 -13.9074 0.965338 -232 1 14.8416 10.5583 1.56689 -2.78575 22.6182 14.2458 -233 2 15.4799 11.2066 1.96334 -16.8252 -10.4846 -9.71145 -234 2 13.9405 10.9259 1.71943 20.5685 -8.6057 -5.43477 -235 1 5.6352 6.7176 4.51351 -9.14706 -11.8638 3.15016 -236 2 6.0003 7.60062 4.53525 2.53301 15.852 -6.04122 -237 2 6.16933 6.24394 5.16122 6.25334 -1.18144 -1.3834 -238 1 8.0084 8.26626 10.2701 -4.49752 14.9075 -15.7864 -239 2 8.53054 8.9292 9.77232 -0.437986 -11.1673 11.0277 -240 2 7.35426 7.95022 9.61336 5.97292 -3.64509 13.4454 -241 1 13.4616 18.4657 5.71166 17.1322 -6.35165 -5.45305 -242 2 12.613 0.202175 5.51075 -18.0122 19.0124 -5.00284 -243 2 13.2587 17.813 6.37409 -3.85709 -10.1746 14.3256 -244 1 0.0252945 2.56986 0.408061 0.439602 -5.22175 -5.84652 -245 2 17.7844 2.56336 0.0359587 -11.4993 -5.28871 3.98864 -246 2 0.277142 3.47535 0.26454 16.627 13.7372 -0.461998 -247 1 12.8639 10.8267 9.72576 -55.6075 31.3565 -11.278 -248 2 11.8723 10.9451 9.72713 30.8534 7.0313 -2.47663 -249 2 12.8724 9.89108 9.83244 20.4971 -22.7651 5.79467 -250 1 0.607625 12.2828 11.1117 24.514 -2.72666 -9.78403 -251 2 18.2964 12.3126 11.1603 -11.5713 5.22338 7.13378 -252 2 1.01642 12.6716 11.9034 -8.98148 -2.79725 -0.830812 -253 1 5.29539 7.3549 13.3064 -7.85772 10.5518 3.63543 -254 2 5.70599 8.16396 12.9287 -0.549664 -12.4206 10.9242 -255 2 5.67568 7.22584 14.1948 2.69835 3.31529 -9.72444 -256 1 1.17555 6.77844 11.9244 -33.9372 -12.3631 -14.3141 -257 2 0.259637 6.99751 11.6106 25.929 -3.06653 9.08527 -258 2 1.58097 7.60434 12.1643 7.59492 14.5493 8.35248 -259 1 15.5141 9.76806 12.4302 -1.8656 17.4266 8.04916 -260 2 15.0855 10.6363 12.2204 12.2826 -22.7347 2.36453 -261 2 16.0019 9.91808 13.2494 -6.58523 -0.731675 -3.13373 -262 1 16.4968 12.5534 5.50851 9.37615 -29.7593 -4.66799 -263 2 16.3074 13.4744 5.68685 -5.44524 15.7433 -9.11055 -264 2 16.3732 12.3531 4.54775 0.322938 17.9758 14.7603 -265 1 6.32376 9.8903 0.169934 -28.7401 -0.365509 -5.18995 -266 2 5.50824 10.2805 0.557378 14.6251 -5.00462 -6.15541 -267 2 7.04833 10.2225 0.694867 12.727 0.898893 11.9262 -268 1 12.1515 6.04661 4.01259 -24.0177 -36.8905 11.864 -269 2 12.231 6.67099 3.30768 1.42994 18.9462 -13.2923 -270 2 11.2548 5.64061 3.89367 21.868 15.3866 4.7403 -271 1 0.316109 12.8908 0.0158726 1.97018 -1.90411 4.82087 -272 2 18.784 13.4984 0.752127 -2.36898 -0.989285 -3.79 -273 2 18.4247 13.2164 17.9164 2.23727 -3.47257 5.47524 -274 1 3.55093 0.0615484 8.6771 30.4928 -5.90286 -4.02028 -275 2 3.49841 18.2151 7.84215 -7.8476 4.22576 -1.41638 -276 2 2.7473 0.557235 8.76228 -21.0031 4.54937 0.225707 -277 1 7.3901 17.5352 4.48573 6.23592 32.7201 -14.6481 -278 2 7.69571 18.4853 4.57976 -11.8279 -33.7706 3.32686 -279 2 7.33788 17.4402 3.51852 2.74261 -6.71083 9.2357 -280 1 9.25 17.16 12.2333 -3.7288 14.5824 3.61249 -281 2 9.26512 16.5009 11.5521 -3.80961 -18.6559 -12.0666 -282 2 10.1634 17.2094 12.5273 3.6148 1.53928 10.2644 -283 1 13.402 13.1082 7.90091 0.220655 -14.9059 29.302 -284 2 13.4302 12.436 8.64233 -5.21958 14.4877 -25.9571 -285 2 13.929 13.8525 8.23076 3.39805 -3.2421 -4.10773 -286 1 14.8025 2.90677 15.4495 23.2091 4.40575 2.70159 -287 2 14.1483 2.29946 15.1328 -14.8482 -16.0174 -4.02081 -288 2 15.4935 2.87296 14.7763 0.208871 3.12507 -3.30872 -289 1 9.90762 15.6519 16.9195 -4.56731 4.54647 -2.1455 -290 2 10.1638 14.7845 16.5964 9.48907 -4.21512 -5.5698 -291 2 9.51082 15.4442 17.7618 -6.39245 0.962418 13.4848 -292 1 11.1953 8.50068 16.6178 -6.68582 -9.72424 -8.69684 -293 2 10.4052 8.01271 16.3331 5.65618 1.52157 -2.37675 -294 2 11.7201 7.85843 17.0918 5.14472 -5.56789 7.7477 -295 1 3.97964 18.2216 16.8609 -11.5365 11.132 -5.80894 -296 2 4.44261 17.5481 17.3724 7.79342 1.98205 9.06349 -297 2 4.16759 0.471834 17.2017 1.31413 -17.4358 -0.663005 -298 1 2.27286 4.25928 8.9046 8.30035 -0.830932 12.3077 -299 2 3.22373 4.0264 8.87035 -15.4899 4.40379 3.11293 -300 2 1.97207 4.14495 9.83591 10.7423 -1.42059 -17.2737 -301 1 9.92348 10.3926 9.8203 -1.21029 -1.85278 -24.2235 -302 2 9.36782 11.1029 9.49607 0.630055 7.16446 -2.16893 -303 2 9.82869 10.3844 10.7566 4.49005 -1.30636 29.4196 -304 1 9.77911 0.915187 10.8241 -1.58049 4.53496 -1.50662 -305 2 9.30516 0.126632 11.1017 -0.152878 -7.87834 6.94802 -306 2 9.15539 1.38664 10.2518 4.51752 0.176684 -4.82426 -307 1 9.1489 15.1729 10.179 6.96198 -6.50551 5.53221 -308 2 8.91001 15.8322 9.53904 -4.06695 15.478 -9.20984 -309 2 8.38415 14.5913 10.1616 -4.75674 -5.76082 4.02117 -310 1 0.743465 9.68917 10.1631 30.9903 9.57445 -5.37239 -311 2 0.884314 10.6156 10.4664 -8.35327 -15.1374 -2.2352 -312 2 1.62506 9.41264 9.82336 -24.2866 3.90606 7.18729 -313 1 17.1113 4.7779 8.02102 2.26389 -23.2748 8.45538 -314 2 16.3418 5.309 8.21811 -5.84575 9.78705 2.38191 -315 2 17.0463 3.99595 8.60382 3.74785 14.695 -9.14029 -316 1 14.847 14.6269 0.171171 -19.7527 -14.4968 -14.2937 -317 2 15.5321 14.9161 0.755334 10.0132 13.2257 15.972 -318 2 14.1228 14.2968 0.729437 5.50655 3.69994 -2.14986 -319 1 3.90456 11.0507 9.5998 -4.69832 -0.998696 -0.0493525 -320 2 3.86255 11.1688 10.552 1.28841 5.10968 9.84865 -321 2 3.27063 11.6917 9.24194 0.0177884 -1.71993 -8.82733 -322 1 11.433 10.7439 1.41897 29.5023 2.97313 10.7876 -323 2 11.6019 11.6536 1.12948 3.85703 -2.03295 -2.25776 -324 2 10.504 10.6413 1.35913 -35.0433 -4.68689 -6.35229 -325 1 13.1835 7.21214 12.6412 -8.23521 -20.1104 -3.47812 -326 2 14.127 7.05932 12.5127 3.33109 -0.638199 4.03042 -327 2 12.8061 6.29857 12.6985 3.22225 19.9882 2.50286 -328 1 9.65928 1.95745 0.843925 10.2182 6.36996 -3.06277 -329 2 8.81763 1.63483 0.51897 -5.65357 2.11518 2.03686 -330 2 10.1334 2.26536 0.0610097 2.29468 0.231167 4.03759 -331 1 10.5974 13.4461 4.57973 -2.39764 -3.17335 8.92217 -332 2 11.4415 12.9723 4.66721 0.170993 3.79528 3.71784 -333 2 10.3828 13.7711 5.47244 5.6647 1.39651 -7.04866 -334 1 14.5805 1.64306 10.9903 3.01891 29.9103 -7.34195 -335 2 15.4206 1.31489 10.661 2.43812 -13.4824 -3.17866 -336 2 14.6923 2.61327 10.8523 -8.77415 -13.7688 6.87151 -337 1 14.4577 12.0498 11.5485 -29.7481 -1.24334 12.4997 -338 2 15.1787 12.3182 10.9897 13.6492 5.38623 -14.4259 -339 2 13.7324 11.7114 10.9784 17.3586 4.51945 3.50834 -340 1 8.16823 5.15587 9.894 -28.9634 21.8059 19.126 -341 2 7.25961 5.26999 10.2972 28.5921 -4.04796 -11.5402 -342 2 8.23961 4.23455 9.67377 -1.01689 -19.4985 -4.69706 -343 1 1.66839 17.0027 18.4477 20.9596 26.331 -27.2012 -344 2 2.19503 17.5247 17.7665 -16.8758 -18.2972 22.1195 -345 2 1.83767 16.0826 18.2308 2.67698 -10.8321 1.22526 -346 1 1.40907 17.4029 15.3161 -1.8056 14.8407 8.29727 -347 2 1.4134 18.2156 15.8633 3.96238 -8.68525 -7.97287 -348 2 0.471831 17.1989 15.2085 1.34275 -7.61847 -1.46046 -349 1 3.49459 5.75594 6.06077 -10.0958 -15.2551 6.44531 -350 2 3.00844 6.4276 6.56158 3.56089 -0.0685925 -1.76679 -351 2 4.03572 6.19023 5.40706 10.0519 13.1926 -8.23224 -352 1 12.6765 9.5142 14.2706 -5.75697 27.7722 -14.2581 -353 2 13.0673 8.79775 13.7668 1.15853 -14.5514 3.26719 -354 2 12.382 9.20431 15.1249 -1.95515 -14.6959 8.85488 -355 1 4.11243 15.2112 7.12768 13.4261 4.57048 -4.21166 -356 2 3.68336 15.9917 6.77855 -13.243 7.84695 -2.74865 -357 2 5.05149 15.4218 6.9541 -4.34911 -9.58911 5.5273 -358 1 0.807347 8.85082 15.1137 12.1653 -16.291 -5.21716 -359 2 0.579225 9.7725 15.0704 -11.1033 15.5539 4.56692 -360 2 1.61112 8.83255 14.5724 -2.7466 -7.45742 -2.63208 -361 1 12.955 8.28126 10.1315 4.47425 -26.4789 2.77461 -362 2 13.6724 7.69661 9.75218 -12.3213 15.4477 18.6624 -363 2 12.7996 8.04439 11.0766 12.5165 -4.13221 -14.8671 -364 1 15.2413 7.99312 3.46307 21.2061 37.6089 -22.4299 -365 2 14.4756 7.7211 2.94477 -5.95544 -17.8301 8.14742 -366 2 15.6187 7.46858 4.17258 -15.9179 -18.0198 8.83427 -367 1 17.1356 6.70525 18.6386 6.47512 25.7091 -12.2215 -368 2 16.6963 5.89525 0.233999 -10.309 -8.75159 3.76643 -369 2 16.4339 7.33237 18.3357 11.2115 -13.3479 10.1501 -370 1 8.91981 7.02641 7.93476 -17.5815 -13.9195 9.00305 -371 2 9.83812 7.25537 7.853 19.0031 7.73693 -0.560136 -372 2 8.849 6.45385 8.72921 -1.20537 6.38433 -11.1549 -373 1 12.4784 0.471427 1.2 -1.5382 -11.3036 2.52426 -374 2 13.1724 0.955828 1.65737 6.96212 2.95671 -0.139484 -375 2 12.8855 0.124586 0.40059 -1.81614 4.12295 -0.743523 -376 1 5.7338 15.0104 14.483 3.21537 -3.99883 -6.81615 -377 2 4.79914 15.0689 14.6899 -13.3072 1.49299 3.3932 -378 2 6.00174 15.8892 14.196 3.10174 7.95604 -0.192962 -379 1 3.73322 6.46389 1.74186 4.97145 -11.2752 -15.478 -380 2 3.41061 7.27444 1.33141 -3.85483 5.16021 2.72417 -381 2 3.71896 6.61791 2.68352 1.01313 6.07651 8.98471 -382 1 3.85612 11.3357 12.3214 9.74989 2.64833 3.1782 -383 2 4.70398 11.747 12.5616 1.03181 -4.89631 -4.08494 -384 2 3.21292 11.8498 12.8111 -10.0411 9.11388 1.93155 -385 1 5.31882 3.86098 15.7247 -14.6622 43.9235 8.42988 -386 2 6.03513 3.29574 15.4808 24.4173 -17.8012 -3.50674 -387 2 5.69837 4.77513 15.8552 -8.87612 -28.0013 -6.19005 -388 1 14.0506 10.0984 4.70507 12.9021 5.9963 -48.2497 -389 2 14.373 9.82203 5.54065 6.42583 -15.3441 32.1568 -390 2 14.6577 9.66966 4.04903 -16.6446 6.96016 16.1133 -391 1 7.63016 17.2999 9.07082 4.88589 -1.83029 4.08955 -392 2 7.05774 17.6443 9.76408 -9.77236 -5.61109 0.722829 -393 2 7.90646 18.0745 8.58282 6.82018 7.73796 -12.3688 -394 1 4.54853 14.4989 3.92298 4.51049 -12.0827 -19.4455 -395 2 4.48676 15.3439 4.34231 1.7531 23.2793 6.06498 -396 2 4.47875 13.8474 4.61218 -0.893081 -14.6097 11.9436 -397 1 14.1162 7.44072 15.859 5.72353 -2.97717 1.52707 -398 2 14.8925 7.45204 15.2793 -3.03398 0.324075 5.79835 -399 2 14.4079 7.84098 16.6936 -1.38652 -1.7593 -3.67135 -400 1 2.91046 18.3824 1.92161 -14.6763 12.8451 -3.99897 -401 2 2.56811 17.7851 1.23066 -1.64793 1.84374 10.7046 -402 2 2.14175 0.293363 2.23042 22.3557 -16.8939 -8.97037 -403 1 8.00583 1.57089 4.46736 31.4122 8.97246 -10.4438 -404 2 7.40416 1.98491 3.8452 -8.42929 2.78546 -1.25861 -405 2 8.8818 1.75969 4.05638 -17.375 -7.71187 12.4181 -406 1 2.50572 14.1939 17.7606 -21.3738 -1.77578 0.320632 -407 2 1.88811 13.4733 18.0291 6.14349 16.4853 -5.08899 -408 2 3.36784 13.821 17.8832 22.941 -11.7322 7.4453 -409 1 0.984409 1.95477 13.9081 14.9076 0.866869 -10.4657 -410 2 1.09683 1.70126 14.8211 1.02253 -2.39927 14.2505 -411 2 18.6933 2.04344 13.7674 -16.8072 2.56857 -0.576968 -412 1 4.29327 0.177122 13.8951 16.4248 3.49785 -13.6548 -413 2 5.17049 18.4046 13.9646 -5.43827 4.9033 -2.01246 -414 2 3.78721 18.4389 14.598 -10.2443 -5.04864 16.3534 -415 1 7.35353 0.990853 18.4538 -34.7507 -7.39683 16.7648 -416 2 7.55815 0.737816 17.5561 -3.16307 -6.20953 -15.156 -417 2 6.35665 0.974064 18.6083 33.4978 7.02218 -7.3799 -418 1 15.8311 18.4256 13.8966 -40.0758 9.01377 -20.0242 -419 2 14.87 18.5763 13.7207 27.6408 -4.60797 -2.68704 -420 2 15.8417 18.2976 14.8321 10.6174 3.57585 21.6768 -421 1 10.2864 4.58419 16.2444 -24.4222 -37.2091 -9.88285 -422 2 11.2299 4.68793 16.3674 13.142 -4.29349 -1.09379 -423 2 10.1171 3.59079 16.124 8.18179 40.05 5.52806 -424 1 15.8917 17.7071 4.46459 -20.0388 -20.4222 2.09772 -425 2 16.4651 18.4471 4.57513 18.3163 24.2221 3.8588 -426 2 15.0409 18.0029 4.83395 4.42355 -1.752 -6.47073 -427 1 6.88773 17.6166 13.9821 -38.4037 0.167583 13.1844 -428 2 7.46394 17.6315 14.7417 15.8748 3.42447 12.5511 -429 2 7.41699 17.4009 13.2391 27.9809 -3.71977 -23.5355 -430 1 13.1764 6.43911 6.52144 -5.83912 -0.258919 -12.4557 -431 2 14.0695 6.77261 6.34605 -1.47407 -3.35023 -0.470203 -432 2 12.7466 6.3372 5.63472 11.513 2.45032 19.1456 -433 1 7.86196 2.29978 9.4638 -2.97627 -2.7765 -21.1046 -434 2 7.31086 2.09746 10.2267 -8.88065 1.6173 3.7395 -435 2 7.37564 1.98398 8.66115 7.69705 6.95472 18.2428 -436 1 15.1916 14.7366 13.8236 -12.2847 5.72199 -1.13466 -437 2 14.8954 15.0381 14.6996 2.36081 -1.57038 -3.3629 -438 2 14.579 15.1371 13.1848 7.3504 -2.29354 4.97967 -439 1 9.39483 8.42303 3.86324 -21.5436 -11.8424 -10.9865 -440 2 10.2164 8.84977 4.07537 16.3384 7.87643 5.27894 -441 2 9.57157 7.47345 3.83359 1.44741 0.673327 1.03302 -442 1 17.655 13.5671 16.4489 -7.58846 13.4511 -15.7424 -443 2 16.7203 13.3469 16.3992 -7.59268 -4.18946 5.70215 -444 2 17.688 14.4057 15.9472 10.2114 -8.11811 3.61388 -445 1 4.94979 10.486 2.86622 25.3355 -10.7625 -10.0508 -446 2 5.84023 10.0991 3.03563 -22.0316 6.96347 2.01482 -447 2 4.71704 10.9487 3.67532 0.603793 8.46932 2.75775 -448 1 3.68042 8.39717 9.8747 -7.87972 -17.3414 17.5888 -449 2 3.759 9.34077 9.71499 3.24219 9.53521 -0.886609 -450 2 3.55014 8.28216 10.8428 3.92085 5.02512 -16.6805 -451 1 15.9973 6.92061 5.87772 4.82031 -5.03924 3.59177 -452 2 16.6812 7.41263 6.34454 2.21588 0.961055 0.440265 -453 2 16.3186 6.0008 5.83915 -7.41322 12.2727 -5.03736 -454 1 15.3004 7.2666 8.94213 -32.1238 -12.1179 -31.7334 -455 2 15.9839 7.55437 9.51768 24.5834 17.5628 17.3411 -456 2 15.1488 7.91682 8.21973 7.72693 -8.10504 16.1569 -457 1 6.21705 12.8062 12.747 -22.7002 13.2796 -10.093 -458 2 7.05571 12.494 13.0465 21.6431 -16.5072 9.89045 -459 2 6.01919 13.5682 13.3077 2.09027 1.41895 1.21426 -460 1 12.1299 4.57596 13.1432 22.4432 17.9492 20.1123 -461 2 12.1793 4.58175 14.1216 4.56317 3.76233 -12.2652 -462 2 11.3861 4.04706 12.9369 -26.6961 -18.2025 -7.73732 -463 1 11.4375 8.07047 7.90979 27.6542 -15.5792 16.7856 -464 2 12.1952 7.52933 7.56059 -23.0528 10.899 -6.13628 -465 2 11.6627 8.11033 8.86659 -7.72222 6.32108 -19.0792 -466 1 16.9453 10.7968 7.63148 -3.5821 -10.5143 21.6719 -467 2 17.6495 10.1525 7.46889 2.86773 -0.504685 -4.5375 -468 2 16.8108 11.3218 6.85057 1.29813 10.4979 -20.4226 -469 1 5.19425 18.0282 10.6847 0.056878 3.62778 8.77145 -470 2 4.66571 17.4143 11.2104 4.95394 3.09506 -2.12913 -471 2 4.57063 18.3664 10.0251 3.33377 -5.62986 -0.929046 -472 1 7.60987 17.4226 1.56636 -8.76834 11.2024 10.6057 -473 2 8.12097 16.6429 1.35059 3.07922 -5.96866 -14.3061 -474 2 7.62904 18.066 0.842261 4.5937 -2.56699 -0.219584 -475 1 1.93734 12.9421 13.6328 4.51097 2.01356 -10.2989 -476 2 1.33249 12.4003 14.1383 -4.04092 -5.16916 8.28012 -477 2 2.1441 13.7105 14.1828 3.43289 -0.0153047 1.69165 -478 1 9.36109 6.77295 14.8254 28.0404 -16.4025 -23.0383 -479 2 9.79586 5.92856 15.0909 -10.7826 13.1246 6.51236 -480 2 9.73683 6.91972 13.9197 -17.1545 2.79671 17.5547 -481 1 15.2759 4.38629 10.7467 0.911226 -10.0818 1.35121 -482 2 16.2063 4.08729 10.7712 -9.28003 7.88291 1.38983 -483 2 15.15 4.95989 11.5268 6.34994 -5.62458 -10.0329 -484 1 11.4488 6.21672 0.0274361 8.35139 15.4334 1.07365 -485 2 11.547 5.26836 -0.0918922 -6.12153 -5.65013 -4.62095 -486 2 10.5221 6.46299 18.5238 -1.7877 -10.3718 -2.04901 -487 1 18.4903 11.4194 14.9121 8.77287 -18.4144 -27.074 -488 2 18.1021 11.8559 14.1353 -5.2902 0.217957 4.39134 -489 2 18.3331 12.0271 15.6113 -5.23497 22.6985 22.6894 -490 1 7.12593 9.28496 7.31024 -23.9992 -6.07508 6.39318 -491 2 6.74279 8.45494 7.66169 4.89732 10.9664 -5.80838 -492 2 8.06011 9.1434 7.29118 23.2007 -3.69072 -2.70719 -493 1 18.3302 15.3588 12.1663 1.84912 0.0598217 5.47138 -494 2 0.628985 15.4631 11.9685 -1.01298 4.74778 -2.81479 -495 2 17.8359 15.8974 11.5264 -1.18931 -3.22386 -0.556154 -496 1 16.5345 4.36456 5.22425 -62.6276 -15.6665 42.2949 -497 2 16.4135 4.0372 6.15475 14.4043 4.47956 -24.0603 -498 2 17.4334 4.499 5.03806 48.2264 1.34274 -11.6623 -499 1 17.733 3.12037 10.7685 2.78093 13.2032 15.2159 -500 2 18.62 3.27348 11.1411 -3.87004 4.46435 -8.2182 -501 2 17.7411 2.21797 10.4818 -1.03268 -21.1847 -12.2715 -502 1 12.2988 18.6545 10.1426 21.4258 -12.4002 -10.8053 -503 2 11.5002 0.459945 10.3706 -28.4452 4.23152 6.39845 -504 2 12.9389 0.72089 10.1511 12.8533 4.08749 0.539844 -505 1 10.4313 9.72872 12.541 3.98701 -3.38274 8.58973 -506 2 11.1703 9.84044 13.1623 -1.01011 3.74187 -3.45859 -507 2 10.4039 8.77038 12.4204 -3.66163 0.188688 -4.07709 -508 1 0.615048 2.63664 7.2276 -9.26807 24.3162 -18.5585 -509 2 0.353188 3.56967 7.37092 2.19049 -16.4853 1.00686 -510 2 0.949026 2.32684 8.06684 4.15829 -4.72879 9.31366 -511 1 0.333537 15.2707 6.93805 -1.63763 -14.4268 -44.2284 -512 2 0.559673 15.3175 7.85021 9.94673 -3.51892 30.6084 -513 2 0.629693 14.3791 6.62643 -7.55161 17.6489 9.10591 -514 1 17.0527 6.91364 14.9743 11.0217 0.359412 -1.38417 -515 2 17.7989 7.54943 14.9113 -7.11537 -10.2599 3.19545 -516 2 17.3979 6.08953 15.3732 -1.90278 10.2985 -1.25317 -517 1 9.14167 12.5321 7.98456 -51.8007 8.58975 -7.36144 -518 2 9.48882 11.7504 7.57305 13.8522 -18.8219 -15.7166 -519 2 8.22261 12.6161 7.58551 34.0094 -0.937982 16.6367 -520 1 1.15656 1.63828 2.76743 -9.76481 2.77041 -4.10292 -521 2 0.864287 2.18836 2.03128 -7.19413 -5.97378 -5.55322 -522 2 1.70002 2.22125 3.28253 11.7483 7.29404 14.7886 -523 1 4.17339 15.1305 9.84913 -14.3711 5.0779 2.99988 -524 2 3.91961 15.3463 8.93389 10.9385 -4.50851 5.90843 -525 2 5.03476 14.6902 9.78793 -0.575875 2.49321 0.528438 -526 1 7.3951 2.27992 14.8377 -1.12966 16.8522 -8.99686 -527 2 7.16414 1.54106 14.2639 1.26623 0.276941 -0.531744 -528 2 7.65338 3.03331 14.2573 -5.05472 -19.0282 8.30824 -529 1 18.3172 14.5403 2.1483 15.3986 5.40572 3.08201 -530 2 0.535799 14.8642 2.50804 -16.0996 -1.12956 -11.071 -531 2 17.7238 15.3001 1.99479 6.48993 -0.927096 4.3539 -532 1 10.0475 2.68059 12.9077 -3.02015 -13.9614 -15.6621 -533 2 9.89167 2.00033 12.2018 7.6523 15.7956 13.7679 -534 2 9.26985 3.25658 12.875 1.66072 1.15674 0.355625 -535 1 2.93978 8.85687 13.107 17.7725 7.3386 -7.69378 -536 2 3.37522 9.71823 12.8547 -12.3312 -24.1388 6.15133 -537 2 3.67473 8.22279 13.2377 -8.38529 8.44125 1.12687 -538 1 3.27106 8.61507 3.79074 -8.49716 -38.7584 59.7131 -539 2 3.66196 9.22584 3.22278 26.3747 36.1018 -32.8858 -540 2 3.70281 8.77413 4.67945 -18.9434 -3.96308 -29.2422 -541 1 5.92777 7.2521 8.64891 -10.8881 -6.62505 3.42768 -542 2 5.84919 6.30478 8.465 1.79189 -1.90292 -1.42585 -543 2 5.07694 7.48175 9.0605 5.83384 2.94932 1.14829 -544 1 14.8827 1.64134 1.82872 -12.6885 -28.1567 -9.76357 -545 2 15.1087 2.39997 2.36476 0.314968 13.4446 -1.58597 -546 2 15.1034 1.73075 0.884031 8.80659 10.9019 15.543 -547 1 8.66156 14.9913 0.655877 15.6167 -4.79217 23.7466 -548 2 9.42437 14.9505 1.28455 -14.0351 0.988592 -13.753 -549 2 7.99981 14.403 1.0655 -3.22335 6.28365 -6.24421 -550 1 15.4067 1.46647 7.20695 -8.82589 -12.8718 -0.882757 -551 2 14.775 0.932663 6.69065 9.74374 4.52972 3.50353 -552 2 14.8641 2.16562 7.57814 -1.0399 11.0322 0.525673 -553 1 4.92475 12.8978 18.4559 2.19674 -3.23744 10.1082 -554 2 5.23586 12.8997 0.738081 -1.33722 2.66651 -10.6279 -555 2 5.70033 13.1343 17.9365 -0.0827318 6.23371 -0.0935372 -556 1 15.3819 8.68528 18.0932 8.72121 10.5448 -14.8557 -557 2 15.8142 9.23534 17.405 -7.78496 -12.8196 8.73029 -558 2 15.2566 9.31777 0.164984 -6.85428 -0.586954 10.5179 -559 1 12.0126 3.13082 18.276 9.47145 -1.72319 12.159 -560 2 12.2482 3.16999 0.564179 -5.55591 0.644277 0.165862 -561 2 12.5655 2.41012 17.9461 -5.90061 -0.236568 -11.7395 -562 1 13.2006 12.6959 5.14014 6.0546 -4.02499 4.06103 -563 2 13.6294 11.8271 5.0147 -6.69767 7.2237 -2.15456 -564 2 13.3727 12.9234 6.07289 -1.67526 -4.52376 -7.3865 -565 1 6.1651 7.14436 0.195504 -22.0894 -12.2339 1.18179 -566 2 6.12052 8.09409 18.9477 10.183 13.9972 -1.43251 -567 2 5.2591 6.87987 0.448218 12.567 -4.05161 -1.41715 -568 1 17.6881 15.878 14.8655 -1.85909 5.77814 22.6605 -569 2 16.7739 16.1608 15.0761 11.3822 -6.39517 -19.8211 -570 2 17.8371 15.675 13.9293 -11.1648 4.64831 -4.02463 -571 1 13.1067 0.88062 16.8301 -1.16362 5.09418 6.26073 -572 2 14.0188 0.56665 16.8428 4.80395 1.33473 -1.08149 -573 2 12.5822 18.7235 16.7479 -0.784604 -6.20947 -5.79489 -574 1 10.8701 14.5014 7.48366 30.6398 4.5327 -13.288 -575 2 10.1924 13.8927 7.76637 -8.27046 -6.89901 6.40521 -576 2 11.688 13.9665 7.40985 -13.0568 5.23738 5.47236 -577 1 17.7216 8.3975 2.13341 -5.03714 18.392 15.6468 -578 2 16.8261 8.35978 2.51012 1.26608 -2.81583 -3.60077 -579 2 17.7343 7.78208 1.41002 -5.68948 -14.3091 -15.2975 -580 1 12.4651 7.83121 2.02849 6.21002 21.8293 -0.701234 -581 2 12.2371 8.77742 1.88873 1.61752 -16.1639 -0.0618129 -582 2 12.1801 7.35781 1.23988 -4.06145 -2.69746 -4.32972 -583 1 11.9912 14.5504 10.3779 26.255 2.08103 -27.6641 -584 2 12.3772 14.5828 9.46952 -12.6474 -4.22617 24.8662 -585 2 11.0517 14.669 10.2537 -15.8484 3.20565 2.09431 -586 1 6.76727 6.87556 15.5462 0.393734 11.8444 22.477 -587 2 7.69535 7.12306 15.3658 -7.56189 -7.86407 -0.973014 -588 2 6.54154 7.32616 16.388 3.13619 -10.9433 -13.6985 -589 1 7.93405 4.43454 13.181 3.70457 37.9343 33.3332 -590 2 7.23909 4.66367 12.5613 -7.79541 1.00974 -8.53955 -591 2 7.95717 5.24214 13.788 5.6586 -32.0049 -23.1645 -592 1 13.3208 12.2124 14.3278 -1.85908 1.78375 8.34338 -593 2 13.1627 11.2597 14.246 -0.36998 0.633125 0.823702 -594 2 13.6236 12.4909 13.4584 3.579 0.31603 -3.71376 -595 1 14.5678 9.48203 7.30395 8.22624 -5.55489 -6.16459 -596 2 15.3274 10.0218 7.53849 6.73854 1.05081 2.13221 -597 2 13.8344 9.86252 7.77014 -14.2105 5.15772 9.40205 -598 1 12.6689 16.8584 3.2838 3.32354 22.4122 -6.02395 -599 2 12.8251 17.4603 4.02708 -0.185303 -8.85949 -0.0347213 -600 2 12.7374 17.4469 2.50984 -1.71014 -6.46341 4.85536 -601 1 0.984375 7.0735 17.3432 34.0501 -3.91376 2.11413 -602 2 0.125246 6.96907 17.7347 -25.3968 2.18392 3.09576 -603 2 0.950307 7.67775 16.5933 -9.77339 5.8232 -4.41721 -604 1 13.0022 4.84407 15.777 5.081 -10.3329 -5.56354 -605 2 13.7485 4.25418 15.5901 -10.0146 -2.33354 7.04552 -606 2 13.4521 5.67804 15.8535 -1.12386 24.7122 1.66863 -607 1 2.36131 3.40053 5.10919 -9.6311 -14.0051 -9.38531 -608 2 1.85776 3.14724 5.88615 -5.89279 -11.6191 4.05299 -609 2 2.64546 4.27356 5.34111 14.5219 19.3293 2.74972 -610 1 8.16093 10.9198 13.7208 -5.48668 -10.5203 36.1407 -611 2 8.01338 10.5218 14.6488 11.4544 18.6016 -43.3573 -612 2 8.9553 10.5154 13.3405 3.89898 -1.19123 3.66799 -613 1 13.0685 1.50992 13.279 -14.1832 25.7313 -25.8855 -614 2 13.6244 1.50815 12.4613 -6.9447 -4.36872 19.5281 -615 2 12.4297 2.25673 13.1075 20.3356 -25.0236 11.2619 -616 1 6.62047 13.6375 2.07221 -5.18984 1.0977 1.00923 -617 2 6.01355 14.0796 2.67998 -4.17105 4.32933 -3.39809 -618 2 7.10668 13.0566 2.65885 8.90022 -6.51269 2.26225 -619 1 15.8066 6.3469 12.5124 13.7748 11.2213 20.1038 -620 2 16.2844 6.87459 11.8544 0.57451 -1.64399 2.92177 -621 2 16.2805 6.52872 13.3684 -12.0243 -5.9969 -18.7155 -622 1 16.7622 0.649503 9.5351 11.3629 -0.534141 16.2257 -623 2 16.8233 18.3334 9.63984 -7.20854 -2.096 2.62458 -624 2 16.3504 0.825019 8.69009 -8.20455 0.909068 -17.3039 -625 1 6.16155 11.6721 8.23727 11.0478 -14.7079 4.32064 -626 2 5.37204 11.4355 8.7099 -18.5694 3.37101 8.66714 -627 2 6.52549 10.7898 8.06052 6.85938 7.24602 -7.48704 -628 1 2.80718 8.60686 0.397493 -27.1124 -12.7057 -15.0387 -629 2 2.16203 8.12721 18.4284 20.3601 19.9434 23.0266 -630 2 2.28863 9.2379 0.937046 1.66532 -5.5958 -10.4069 -631 1 10.1061 10.2794 6.574 -2.68384 6.39054 8.98367 -632 2 10.587 9.61275 7.07222 2.60765 -6.52577 4.24337 -633 2 10.6348 10.4062 5.77746 -5.53346 0.236498 -3.27199 -634 1 6.84319 15.7735 6.74802 2.92919 -7.52667 3.13791 -635 2 7.22287 16.2754 7.48672 -6.2609 -2.86584 0.474311 -636 2 7.16745 16.2182 5.95944 -1.73758 9.59963 -7.48558 -637 1 6.59004 12.8453 5.92771 5.9232 5.70246 -10.7633 -638 2 6.81648 13.7523 6.14266 -3.08056 9.02497 3.95142 -639 2 6.18071 12.4806 6.71128 -2.95494 -1.85994 5.08984 -640 1 16.7187 12.5557 9.81602 -6.97981 -8.42056 3.44329 -641 2 16.7367 11.9049 9.10465 3.04519 -4.31121 0.702836 -642 2 17.0063 13.3635 9.40922 2.88649 12.8114 -1.84814 -643 1 6.30344 2.78963 2.73877 -9.04367 -13.9111 -2.70816 -644 2 6.4136 3.72217 2.50807 2.58545 1.58307 -3.30667 -645 2 5.8765 2.3355 1.98292 3.38351 11.0448 5.4768 -646 1 10.696 2.92954 3.25253 -4.78239 0.546409 -3.48797 -647 2 10.285 3.77274 3.47459 -3.26512 -0.523652 -3.33277 -648 2 10.2907 2.61783 2.41902 1.90367 1.74508 6.25714 -ITEM: TIMESTEP -100 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.7952 6.55188 17.82 -14.0925 -19.7636 -3.75378 -2 2 7.88023 6.44026 18.1695 19.5523 6.07432 -5.80163 -3 2 8.99571 5.7855 17.2401 -2.64216 11.7935 9.74201 -4 1 0.13387 8.39658 6.71777 11.0686 -17.0219 51.8315 -5 2 0.297964 8.15416 5.82611 3.65759 -8.78146 -34.4276 -6 2 0.663997 7.73523 7.26654 -21.1289 27.238 -19.6589 -7 1 8.71966 0.469223 7.04147 6.63626 1.40123 -3.67752 -8 2 9.62406 0.435013 6.6778 -11.0722 1.83914 2.93454 -9 2 8.2146 0.970711 6.38506 4.19741 -2.20649 2.49068 -10 1 6.44826 1.6863 11.7796 22.1018 -16.0737 -10.0998 -11 2 5.81214 2.23354 12.2013 -20.9633 15.3476 12.0772 -12 2 6.02072 0.836228 11.6256 -4.8988 -3.15305 -3.34718 -13 1 6.89097 5.45035 2.38694 -14.0878 18.1315 0.804401 -14 2 6.23022 6.01625 2.92115 27.2653 -21.4077 -23.7527 -15 2 6.91491 5.77412 1.45583 -9.40281 2.39732 25.4334 -16 1 16.2334 10.2315 16.0664 1.22095 -12.8583 -8.35396 -17 2 17.1105 10.2758 15.679 0.521344 2.88453 0.293596 -18 2 15.9464 11.1361 16.1778 -3.48259 10.2735 3.78324 -19 1 10.8573 15.0007 2.35193 -8.17785 -20.274 -7.01899 -20 2 10.8024 14.5151 3.19219 -3.98998 0.859093 -1.88791 -21 2 11.3201 15.8014 2.5578 8.92048 16.4226 10.3474 -22 1 17.1726 8.21805 11.024 14.0848 -19.0512 -23.2094 -23 2 16.691 8.91369 11.4632 -8.36385 12.6057 9.94503 -24 2 17.8921 8.64427 10.518 -5.71892 -0.131476 8.97419 -25 1 14.5956 15.9799 16.3132 20.7515 -13.8502 3.42179 -26 2 13.7469 16.3872 16.1713 -21.6627 3.23661 7.28294 -27 2 14.5521 15.3865 17.0935 -1.40849 8.21009 -3.21798 -28 1 12.1509 13.2395 0.573493 6.57205 3.5904 2.72349 -29 2 11.837 13.3986 18.3303 -3.80405 -1.74926 -15.723 -30 2 11.7012 13.9105 1.09717 -2.12612 0.929616 9.94365 -31 1 9.32377 5.48511 3.80515 37.2224 0.919853 24.8976 -32 2 8.88878 5.295 4.65312 -11.8166 2.00864 -7.28102 -33 2 8.70235 5.44743 3.10202 -35.0307 -2.6733 -15.0358 -34 1 1.53449 3.88906 11.5762 -21.4592 42.8438 -26.3691 -35 2 1.39761 4.77552 11.9865 7.05639 -9.88004 -9.22537 -36 2 1.89707 3.34621 12.2331 21.1403 -27.4328 37.6181 -37 1 2.11621 6.94729 8.0812 -5.52003 -16.2776 -1.04121 -38 2 2.5746 7.45442 8.7366 8.45236 15.6822 11.2536 -39 2 2.08388 6.07661 8.50513 -4.57751 -6.44388 -7.47435 -40 1 5.24695 4.43578 7.8028 -6.30612 26.2857 -2.69952 -41 2 5.36677 3.49844 7.65426 0.215716 -12.5366 -1.65761 -42 2 4.56392 4.76953 7.18377 10.1949 -9.65667 2.91339 -43 1 3.43524 2.88686 17.4376 -21.7675 5.87472 14.6558 -44 2 3.90981 3.17382 16.6701 17.8952 10.4272 -14.0542 -45 2 2.87759 3.6541 17.6984 8.18662 -9.04753 2.1829 -46 1 7.55778 5.57378 6.15352 3.99821 9.40639 19.9011 -47 2 8.12518 6.20749 6.66299 -12.9927 -14.0765 -9.88952 -48 2 6.98227 5.15891 6.82729 7.75312 -1.10557 -10.9113 -49 1 9.77611 7.00478 12.0482 -6.90333 -2.64414 -8.04886 -50 2 10.0224 6.11753 11.7611 0.642082 2.81741 -0.891425 -51 2 9.0843 7.2891 11.4183 2.80801 -0.947675 5.79882 -52 1 14.1423 3.90191 8.16294 -23.6925 4.35767 -24.2753 -53 2 13.5235 4.53411 7.72337 18.2577 -11.8103 7.89417 -54 2 14.4024 4.31063 8.97869 6.95814 7.70003 16.5888 -55 1 4.54437 17.2359 3.8519 4.03565 10.1791 3.31349 -56 2 5.34213 17.7268 4.08304 4.36901 -6.62302 -0.267376 -57 2 4.17051 17.7127 3.09453 -6.96766 -2.87365 4.53203 -58 1 16.1339 16.4921 10.5971 24.4543 -12.0388 -34.7313 -59 2 15.4578 16.6815 11.2098 -23.1752 5.77424 26.3474 -60 2 15.6745 15.9439 9.92709 9.81353 9.26167 7.23238 -61 1 1.98282 4.87023 -0.0102057 11.328 -31.2723 15.691 -62 2 2.56866 5.25094 0.666382 -3.10152 5.14206 -1.69339 -63 2 1.65849 5.5885 18.1127 -8.58794 22.0564 -11.6074 -64 1 11.0975 13.3336 16.4568 21.334 -26.4555 -13.6253 -65 2 10.7319 12.43 16.5661 -7.83355 14.7592 4.38577 -66 2 11.7328 13.1734 15.7328 -3.59268 8.82171 6.12988 -67 1 9.983 10.9188 16.8195 21.8027 -17.9597 14.5818 -68 2 10.5015 10.1139 17.0687 -12.258 16.9146 -11.8156 -69 2 9.08607 10.6082 16.6912 -8.94921 1.38614 -3.26281 -70 1 11.9148 17.5563 13.4787 -11.9158 -12.5975 -1.23623 -71 2 12.5676 17.2101 12.8515 -0.0246338 2.67811 4.16536 -72 2 12.0003 18.5089 13.4756 8.75914 10.3848 -3.31648 -73 1 6.43245 9.54572 12.2957 1.63429 -3.34072 -14.2423 -74 2 7.08046 9.15867 11.6656 -10.0512 7.63496 6.98562 -75 2 6.90317 10.1892 12.8448 2.76093 -9.73394 -7.4892 -76 1 16.2985 12.7819 2.78073 -6.76278 9.02259 -0.251856 -77 2 17.1507 13.1937 2.56739 -3.11425 -2.92719 1.79117 -78 2 15.6658 13.5347 2.78258 7.1706 -12.5209 -0.796151 -79 1 0.705375 12.7757 5.80641 -31.4327 0.785322 -26.0818 -80 2 0.964058 12.7408 4.86595 9.86444 -3.28161 8.94612 -81 2 18.3663 12.6813 5.72517 19.7421 -2.33124 11.5636 -82 1 5.30386 16.3127 18.466 5.80758 -1.43031 -6.37222 -83 2 5.80257 15.6526 17.9366 -5.42534 13.184 13.7491 -84 2 5.92544 16.7092 0.45256 -3.43112 -6.46136 -2.11967 -85 1 0.781035 7.63768 4.09742 11.023 -5.93732 13.9838 -86 2 0.258202 7.96457 3.37539 -14.755 3.95315 -10.1558 -87 2 1.66078 7.97253 3.8829 3.26007 -0.00880383 4.41534 -88 1 3.24417 9.16605 6.56429 -20.4701 -14.3326 2.83801 -89 2 3.57159 8.65908 7.31953 1.49107 7.58135 -6.52778 -90 2 2.30098 8.88971 6.4655 20.5558 12.7829 2.43715 -91 1 7.26627 10.4004 16.2591 -15.7562 -6.32656 27.9079 -92 2 6.82075 11.2368 16.4586 5.73239 -2.42146 -6.93429 -93 2 6.93167 9.82605 16.9811 6.22417 8.86745 -10.8084 -94 1 10.9892 0.849679 5.07849 4.12027 -5.76689 -13.93 -95 2 11.0513 1.64213 4.53259 0.725375 9.02843 9.39609 -96 2 10.6504 0.238952 4.4041 -0.868918 -3.08012 11.6628 -97 1 4.18223 2.98976 13.1617 1.80285 -9.79496 -4.9743 -98 2 4.46754 3.28562 14.0477 -4.0491 -7.36491 -7.89898 -99 2 4.03841 2.01285 13.1683 3.67857 16.3758 11.7633 -100 1 8.4888 10.2856 1.85141 10.3375 -10.6918 -8.28538 -101 2 8.43451 10.9691 2.52904 -3.58901 -0.686288 7.94652 -102 2 8.82874 9.48425 2.29142 -6.1923 10.8646 1.43904 -103 1 10.2336 1.64305 15.4458 -13.2429 9.10796 4.38269 -104 2 11.1732 1.63861 15.572 16.9305 -2.55664 -1.17381 -105 2 10.0536 2.05804 14.5895 6.55462 -3.46994 -1.37038 -106 1 2.58993 12.7242 7.97336 -7.23425 -8.94691 3.8681 -107 2 3.01571 13.5704 7.82234 5.57764 5.06786 -6.45979 -108 2 1.98486 12.5774 7.23174 0.806159 4.05811 0.362671 -109 1 3.90685 11.8307 5.02738 -19.955 -7.05304 -0.3571 -110 2 3.70751 11.1281 5.68153 3.09094 12.242 -8.4391 -111 2 3.06715 12.0092 4.53628 19.8771 -7.15241 7.2697 -112 1 6.7679 14.5791 16.9276 2.77817 -6.983 11.0716 -113 2 7.71708 14.7379 16.9268 0.980214 1.28706 0.809355 -114 2 6.44853 14.8723 16.076 -0.709014 -5.22289 -12.1565 -115 1 14.1752 14.508 3.1348 7.33594 -12.7834 -7.22412 -116 2 13.6105 15.2801 3.10139 -3.55206 9.35654 4.80996 -117 2 13.7682 13.8754 3.73922 -4.33905 3.15851 6.00261 -118 1 8.77346 18.0937 16.1268 -49.3086 -19.2657 7.09896 -119 2 9.29148 17.2891 16.2682 10.0054 9.31596 -1.94744 -120 2 9.22615 0.228463 15.833 27.8858 8.66202 -5.29688 -121 1 4.63977 1.75161 4.89947 12.6555 12.3233 -26.7382 -122 2 3.82082 2.25711 4.97207 0.159842 -3.07614 2.23584 -123 2 5.05477 2.09313 4.05862 -7.26402 -10.6651 28.8422 -124 1 15.0293 12.6717 16.5117 -23.31 -0.861404 35.6256 -125 2 14.4426 12.7177 17.3057 24.815 2.28331 -11.4604 -126 2 14.393 12.496 15.8301 -9.60755 -0.359254 -28.8722 -127 1 15.7282 18.4115 16.8424 17.2085 30.6847 -2.58542 -128 2 16.585 18.5255 17.3163 -17.0651 -10.3906 -2.34083 -129 2 15.5073 17.4884 16.7844 1.64687 -19.4864 2.05956 -130 1 1.3653 1.32145 16.674 4.57571 12.7751 22.4809 -131 2 2.22966 1.72757 16.8986 -13.3853 -7.67206 -8.47788 -132 2 0.843747 1.53379 17.4789 2.23908 -6.3926 -16.4011 -133 1 18.2502 4.28823 15.9426 5.59379 -7.24598 -18.3859 -134 2 17.8025 3.49471 15.6029 3.53909 11.4984 4.55434 -135 2 0.380345 4.42598 15.3659 -10.3938 -1.91133 11.4 -136 1 12.0179 17.0993 16.1449 -24.7595 -29.8482 27.6473 -137 2 11.2904 16.5264 16.5371 30.7476 29.6052 -3.96723 -138 2 11.7854 17.0696 15.2267 4.30162 8.23296 -25.5613 -139 1 16.0455 2.77586 18.2041 10.6955 -6.31261 -1.53201 -140 2 15.9135 3.65525 18.5895 -10.0784 -5.09061 -10.2232 -141 2 15.7148 2.7749 17.2908 -2.70848 4.2718 2.75475 -142 1 6.57887 13.7167 10.0128 0.388305 24.4332 24.1101 -143 2 6.2636 13.3347 10.8463 6.37938 -3.40375 -0.55213 -144 2 6.43171 13.0818 9.3305 3.17506 -19.669 -12.997 -145 1 10.1062 18.565 2.71626 12.0596 2.32822 -17.6158 -146 2 10.7563 0.294125 2.0815 -9.9929 -7.47975 8.60443 -147 2 9.2984 18.4331 2.20633 -1.12272 -0.999648 5.59115 -148 1 3.10044 17.6571 6.21769 -0.590198 -1.20238 18.0356 -149 2 2.16339 17.7471 5.9649 14.558 -0.242179 -11.811 -150 2 3.6505 17.6877 5.42436 -8.00238 0.252249 -9.63341 -151 1 12.5899 16.7797 7.85568 11.434 -9.28582 -14.859 -152 2 11.8995 16.1049 7.73478 -4.76829 8.38316 1.604 -153 2 12.3367 17.3735 8.55676 -7.89443 8.69289 16.0625 -154 1 14.8958 15.3252 8.42405 -10.9907 16.0866 -10.412 -155 2 14.2257 15.9607 8.05927 9.60746 -16.915 15.6813 -156 2 15.568 15.2992 7.73812 1.83068 -0.846784 -8.90808 -157 1 17.9236 18.2959 0.16927 -20.6229 -20.5305 -14.2597 -158 2 18.7101 17.7336 18.8116 8.98564 4.8691 -3.01699 -159 2 18.0908 0.428516 0.675884 12.0916 17.8267 11.1415 -160 1 0.800533 10.4853 1.48213 -15.9305 -52.1134 32.1201 -161 2 0.0210499 9.87138 1.72712 35.348 27.3948 -12.4938 -162 2 0.488783 11.092 0.839839 -12.4886 25.7711 -24.5144 -163 1 1.85398 12.3107 3.26054 -2.39029 3.71051 2.5874 -164 2 1.61156 11.5651 2.68837 -2.80207 3.45241 0.205878 -165 2 2.01622 13.0664 2.66785 -2.08994 -5.59574 4.32216 -166 1 0.726068 17.2941 4.97534 23.1964 8.93599 -27.6283 -167 2 -0.00504426 17.9045 4.96895 -11.3657 3.83105 9.40925 -168 2 0.6848 16.6356 5.64734 -16.8394 -17.6158 22.5419 -169 1 0.979774 0.931094 9.39103 18.34 6.67236 9.68687 -170 2 1.13606 0.587208 10.3041 -6.25966 0.627701 -15.4141 -171 2 0.222638 0.493139 9.00427 -6.20505 -6.29115 6.11619 -172 1 16.8132 2.44689 13.4524 12.1018 18.2567 -5.29927 -173 2 16.9941 2.74318 12.5312 -5.60486 -9.11594 12.8952 -174 2 16.5475 1.52939 13.4414 -4.39811 -15.2301 -8.28386 -175 1 2.68823 16.0572 12.0971 4.35106 -7.5731 1.60029 -176 2 3.00862 15.6347 12.9147 -3.00711 3.68751 -12.4652 -177 2 3.25289 15.7623 11.3532 -3.53001 -2.50035 7.7005 -178 1 16.365 15.3972 6.07793 1.10786 -2.726 6.22736 -179 2 17.2616 15.5854 6.39959 0.338369 -3.43469 -2.74975 -180 2 16.1217 16.1306 5.49548 2.77772 2.55878 -2.13745 -181 1 5.71885 5.23685 11.7571 -1.38587 -22.0348 -7.59079 -182 2 5.34065 5.94353 12.2818 1.95161 11.9795 4.35233 -183 2 5.13977 4.47517 11.9216 1.17844 4.76848 -1.31072 -184 1 15.1029 4.9502 0.771222 1.99697 3.13949 16.3358 -185 2 15.0181 4.74755 1.72068 1.03511 -0.706475 -1.64751 -186 2 14.2572 5.32925 0.539529 -7.17443 2.24029 -6.36177 -187 1 16.4241 16.5209 1.77175 11.7834 22.2537 -31.9797 -188 2 16.1353 16.901 2.59837 -3.82757 4.70614 16.3909 -189 2 16.7243 17.3043 1.2165 -7.10171 -29.7856 17.5505 -190 1 0.166785 4.90105 4.02875 -9.807 6.14851 -6.2016 -191 2 0.490919 5.80972 4.19933 1.47178 -10.2493 -2.87817 -192 2 0.85797 4.25703 4.16889 13.481 4.94217 6.1798 -193 1 2.95388 15.1092 15.162 10.7369 -8.35154 -8.83455 -194 2 2.79081 14.8128 16.074 0.0767364 3.70074 1.09557 -195 2 2.55949 15.9866 15.0864 -8.26758 5.41964 7.36053 -196 1 1.08589 14.7081 9.5149 24.8711 -1.95174 9.92838 -197 2 2.02655 14.926 9.73253 -22.6422 -7.57261 -8.5802 -198 2 0.981604 13.769 9.74603 1.17561 7.47496 0.770389 -199 1 13.5787 16.5188 11.5692 -12.2314 13.2219 -8.78769 -200 2 13.3397 17.246 10.9551 -0.181138 -8.24863 9.65793 -201 2 12.9892 15.7954 11.3146 2.83531 -7.80051 -5.41791 -202 1 4.81777 1.55092 0.678258 -26.6156 -3.92273 4.29753 -203 2 4.35705 2.21925 0.160828 3.99581 1.83661 -5.90848 -204 2 4.05187 1.04139 1.04246 22.8613 -3.7169 0.169547 -205 1 1.54475 18.6679 11.892 -7.41525 16.2224 7.56704 -206 2 1.47416 0.586534 12.6867 1.33096 -5.97454 -6.01551 -207 2 1.79005 17.7987 12.209 7.72027 -7.46968 0.191542 -208 1 11.4358 10.1471 4.23265 -10.894 -3.87129 -8.35951 -209 2 11.2613 10.4034 3.31126 9.28636 4.56211 3.82985 -210 2 12.3915 10.0236 4.32197 -4.85978 3.43988 -0.432274 -211 1 8.20336 12.1359 3.88849 -13.0458 16.1374 35.7669 -212 2 8.99874 12.5954 4.16275 16.0075 -1.33649 -14.8839 -213 2 7.69556 12.2697 4.73273 -2.96338 -15.3566 -29.2591 -214 1 14.5957 4.06338 3.37559 11.9385 -4.24509 -11.5663 -215 2 15.1907 4.01381 4.14053 1.35901 4.80596 -1.61984 -216 2 13.7786 4.41816 3.71066 -15.4173 6.10577 6.17301 -217 1 5.71905 1.6749 7.61995 8.80947 6.26404 67.7498 -218 2 5.099 1.08549 8.07836 1.13728 7.44943 0.131268 -219 2 5.55556 1.51371 6.73852 -13.1925 -8.9768 -74.4163 -220 1 17.8986 1.04478 4.82737 2.1754 -1.83476 -0.744307 -221 2 18.4917 1.14925 4.06283 -1.19754 2.46044 8.41233 -222 2 18.3052 1.49477 5.5864 -1.29774 -0.0865267 -3.68542 -223 1 6.84138 9.15652 4.5536 4.1666 1.31036 -3.45285 -224 2 6.90548 9.53593 5.43168 -5.85674 1.32054 6.56912 -225 2 7.76285 8.95875 4.34348 -1.51129 -0.833856 -3.18299 -226 1 2.51554 14.7147 2.08788 -0.0450507 -1.43316 -6.26715 -227 2 3.18184 14.7861 2.78103 3.7873 -1.55841 0.251503 -228 2 3.00277 14.5163 1.27395 -5.30581 6.45149 3.77223 -229 1 17.2192 13.0031 13.0554 -12.0926 -3.19634 4.57291 -230 2 16.3553 13.3969 13.3572 27.3304 0.34804 -8.60607 -231 2 17.7786 13.6982 12.6582 -16.3476 4.90844 7.68697 -232 1 14.8182 10.5634 1.61386 4.26778 13.3748 6.0388 -233 2 15.4677 11.1895 1.9919 -6.32062 -5.48184 -5.48699 -234 2 13.979 11.0422 1.62876 3.88819 -6.35193 -1.63244 -235 1 5.61579 6.74404 4.50101 -16.4591 -25.6922 -2.42498 -236 2 5.98931 7.61359 4.54862 8.72135 21.7956 -0.434523 -237 2 6.18395 6.1944 5.05334 5.89398 3.69136 0.98365 -238 1 7.99723 8.25195 10.2692 14.8304 8.84149 10.0706 -239 2 8.65992 8.88256 9.91656 -9.90097 -8.80766 -1.78449 -240 2 7.59566 7.7759 9.52484 -1.48617 9.19501 4.49734 -241 1 13.4628 18.4324 5.71378 17.6235 1.75148 -9.47684 -242 2 12.708 0.350866 5.56458 -19.7852 7.87128 -2.36248 -243 2 13.2811 17.9777 6.53219 -7.30606 -12.1428 7.93723 -244 1 0.0668655 2.55772 0.44163 -1.64079 -15.5797 1.12414 -245 2 17.7792 2.62308 0.158326 7.01821 10.3157 -4.2768 -246 2 0.560589 3.37114 0.261458 -5.35649 7.7487 -2.70304 -247 1 12.8473 10.8167 9.6749 -29.1069 48.3462 -20.1155 -248 2 11.856 10.995 9.62541 32.1605 -20.6147 5.13184 -249 2 13.0142 9.92242 9.94244 -8.5776 -22.9331 5.75343 -250 1 0.607197 12.3488 11.1216 10.7177 -2.21067 3.69277 -251 2 18.3016 12.4338 11.1296 -15.0263 -0.672926 -5.71109 -252 2 0.887353 12.7089 11.9725 7.71276 -2.01358 -2.19338 -253 1 5.32001 7.36668 13.2938 5.32433 15.1635 7.63099 -254 2 5.70557 8.20602 12.9842 -2.91102 -7.98825 -6.07053 -255 2 5.82609 7.21997 14.1065 -9.96591 -5.08448 1.55341 -256 1 1.1733 6.74916 11.943 -30.749 -23.7015 -12.6924 -257 2 0.265139 7.01822 11.7017 14.0517 -0.957096 2.97943 -258 2 1.61086 7.53614 12.2133 15.6557 23.6476 13.031 -259 1 15.5486 9.75906 12.4999 -0.653644 29.4777 3.96245 -260 2 15.1521 10.5891 12.1135 7.41979 -25.1975 16.8694 -261 2 15.9641 10.0301 13.3422 -9.48671 -5.05259 -12.6364 -262 1 16.5044 12.5382 5.51299 -3.50049 1.7151 -41.7779 -263 2 16.2902 13.4721 5.54585 0.30498 11.7411 21.1442 -264 2 16.3754 12.4207 4.53497 7.77761 -11.637 24.1999 -265 1 6.32544 9.92844 0.21289 -23.4091 -5.64021 -11.1485 -266 2 5.58447 10.3552 0.689761 9.59747 -6.57127 -5.34636 -267 2 7.10511 10.1371 0.71679 14.7949 3.34633 14.2781 -268 1 12.1134 5.97718 4.01208 -22.8865 -14.7559 9.656 -269 2 12.2541 6.73773 3.46345 4.76282 13.7738 -16.8186 -270 2 11.1454 5.80116 3.92348 22.2207 -1.187 3.16864 -271 1 0.310021 12.9061 0.00438974 -4.95288 1.79463 -7.14095 -272 2 18.578 13.473 0.695812 6.768 -1.51286 0.947724 -273 2 18.4929 13.1888 17.8371 0.864006 -6.25549 9.7975 -274 1 3.57649 0.0893425 8.67318 10.7138 1.44606 -23.5182 -275 2 3.53585 18.3471 7.78602 0.204258 -6.73647 -0.0210952 -276 2 2.75019 0.556646 8.71194 -17.5671 6.50862 13.0872 -277 1 7.32229 17.553 4.46711 -1.8346 22.7033 -6.51397 -278 2 7.49747 18.5341 4.60164 1.92735 -36.6431 -12.1684 -279 2 7.43093 17.3591 3.50845 0.44318 8.65947 16.4016 -280 1 9.23372 17.1692 12.2368 -1.40541 18.7929 10.7586 -281 2 9.17923 16.5713 11.4947 6.54031 -16.824 -6.24154 -282 2 10.1445 17.1937 12.5849 -6.50468 -4.83213 -2.69749 -283 1 13.3883 13.1392 7.89062 -8.44361 -29.718 12.0449 -284 2 13.2983 12.3346 8.48336 5.26587 25.8846 -16.8323 -285 2 14.1176 13.673 8.22732 -1.02664 3.48474 5.19869 -286 1 14.8313 2.83639 15.4549 13.5448 -0.0778016 6.35676 -287 2 14.1767 2.18003 15.2177 -4.87233 -8.03631 -4.89691 -288 2 15.4971 2.82305 14.7488 -5.52573 3.83225 -1.21536 -289 1 9.88985 15.6498 16.9162 -1.5178 12.6863 -12.8881 -290 2 10.4068 14.8878 16.6522 -4.3383 -15.6303 0.424585 -291 2 9.57752 15.4658 17.7984 -6.29913 -5.39682 13.2163 -292 1 11.1832 8.45041 16.604 0.69795 7.62392 -5.91094 -293 2 10.4558 7.91494 16.2714 -2.08228 -2.22425 -3.83894 -294 2 11.7364 7.86183 17.1086 3.16052 -9.92137 8.33691 -295 1 3.98058 18.2281 16.8796 4.69725 -6.17709 8.80305 -296 2 4.47544 17.5796 17.4031 -3.04366 -6.21568 -3.2578 -297 2 4.2975 0.415113 17.2284 -3.71051 8.24157 -1.82763 -298 1 2.31186 4.29334 8.90298 15.9673 -19.5394 32.2139 -299 2 3.25638 4.01729 8.88792 -18.4415 10.5974 -6.3491 -300 2 2.00846 3.99585 9.80326 5.50039 13.6474 -24.2252 -301 1 9.93626 10.4071 9.85717 -7.16433 6.26663 -15.7674 -302 2 9.36967 11.1624 9.60099 8.89086 -7.49456 6.1891 -303 2 10.0442 10.3828 10.8072 -0.648607 3.91668 13.0823 -304 1 9.8312 0.910661 10.8223 11.6198 7.73817 -5.63486 -305 2 9.46664 0.0599513 11.0613 -12.5627 -8.03565 7.40448 -306 2 9.23233 1.33675 10.1908 -3.5905 -1.89286 -1.84539 -307 1 9.13587 15.2239 10.1542 8.27875 -9.17261 13.8125 -308 2 8.75897 15.8188 9.50902 -6.94043 7.83547 -6.48358 -309 2 8.46187 14.5466 10.3059 -2.40816 2.69742 -4.7236 -310 1 0.685213 9.67274 10.114 -7.63752 22.5158 18.5003 -311 2 0.719625 10.5209 10.6443 4.69174 -21.4783 -21.4849 -312 2 1.56632 9.47392 9.79675 4.15873 2.44002 -0.184199 -313 1 17.1428 4.74332 7.9842 -7.49261 0.0436566 15.7002 -314 2 16.4923 5.43036 8.24486 9.33931 -9.59151 -5.74994 -315 2 17.1543 4.09081 8.70481 -1.62938 8.73821 -5.69634 -316 1 14.873 14.5838 0.184633 -12.5055 -0.863041 8.47648 -317 2 15.4452 15.0773 0.785336 2.49238 5.2379 -3.7088 -318 2 14.1221 14.3325 0.749692 6.56524 -1.80757 -8.31994 -319 1 3.93739 11.0893 9.63941 -1.02455 -14.3236 -20.6383 -320 2 3.83455 11.1931 10.5803 -4.40039 8.60569 15.1914 -321 2 3.22961 11.5882 9.19534 2.92088 3.20496 1.27781 -322 1 11.4787 10.7372 1.42758 24.3197 -0.772389 9.7934 -323 2 11.803 11.5915 1.09275 -4.97826 -3.71445 3.9898 -324 2 10.5984 10.6629 1.1011 -26.1902 -1.18673 -8.43185 -325 1 13.1873 7.21634 12.6041 -15.1781 -16.7535 7.59792 -326 2 14.1321 7.04558 12.6338 7.66113 -4.04391 -1.22332 -327 2 12.7625 6.33802 12.7657 6.99529 16.5731 -3.03327 -328 1 9.70202 2.01155 0.798053 14.7354 3.6785 18.4689 -329 2 8.80874 1.78739 0.563168 -12.7542 -2.84597 -8.5823 -330 2 10.1462 2.35336 0.0231027 2.1886 1.53799 -6.67264 -331 1 10.5601 13.4177 4.61479 15.5689 5.45852 21.4774 -332 2 11.4398 12.9929 4.68798 -8.71776 0.745444 -2.53542 -333 2 10.4627 13.8549 5.48714 -1.1208 -2.16649 -13.1077 -334 1 14.6135 1.64587 10.9888 -15.9483 2.47769 1.03658 -335 2 15.3653 1.14828 10.6398 3.3395 9.35485 -7.37665 -336 2 14.6055 2.55489 10.6162 9.33106 -12.1869 7.67578 -337 1 14.4205 12.072 11.5247 -14.0438 -11.3661 -21.2086 -338 2 15.2325 12.1783 11.0185 5.83651 11.9615 0.736203 -339 2 13.7775 11.7491 10.8405 12.2041 8.47933 23.407 -340 1 8.16075 5.17074 9.91542 -32.2508 22.4833 15.2463 -341 2 7.26447 5.43351 10.2769 29.6925 -9.34554 -9.10024 -342 2 8.08912 4.23235 9.75273 2.68018 -15.2376 -3.85437 -343 1 1.73754 17.0197 18.4251 17.7604 24.8388 -20.6387 -344 2 2.31535 17.5448 17.7835 -20.2636 -19.608 22.2942 -345 2 1.91865 16.0976 18.2314 3.71033 -9.13614 -1.37747 -346 1 1.38218 17.4352 15.3141 25.6123 -1.10879 -8.05345 -347 2 1.40837 18.2867 15.7687 -7.1514 0.273564 3.63966 -348 2 0.483975 17.1212 15.2601 -14.2857 -2.70278 3.05549 -349 1 3.46713 5.71669 6.03858 -5.21329 -0.208659 9.269 -350 2 3.09179 6.35885 6.66621 -4.29108 -6.04245 -5.71481 -351 2 3.94628 6.22951 5.39233 13.1871 8.33197 -8.25473 -352 1 12.7108 9.52885 14.2713 4.43437 -19.6411 -8.16456 -353 2 13.1132 8.73466 13.871 -3.04318 14.9787 -8.97539 -354 2 12.4252 9.15135 15.1011 -11.0135 5.38653 13.5706 -355 1 4.12803 15.1962 7.19495 12.4066 -8.66704 -3.75127 -356 2 3.59847 15.8823 6.77325 5.03517 9.17322 -2.57748 -357 2 5.08076 15.3227 6.96437 -18.0652 5.77836 0.725546 -358 1 0.842345 8.89099 15.1297 2.31502 -25.1166 0.479797 -359 2 0.506769 9.78853 15.0967 4.66165 8.13805 -4.97691 -360 2 1.56169 8.8202 14.4757 -4.5077 5.49756 1.76436 -361 1 12.9722 8.22706 10.1223 30.4908 -35.0116 2.62512 -362 2 13.7358 7.69898 9.75664 -18.6412 19.8455 -0.140907 -363 2 12.9154 7.83668 11.013 -6.3959 11.2287 -1.2259 -364 1 15.209 8.0796 3.38747 1.18456 -35.8933 6.76248 -365 2 14.5518 7.57266 2.91157 -10.3511 16.9608 -18.4151 -366 2 15.3784 7.42989 4.0872 14.9983 19.582 11.3682 -367 1 17.1108 6.70081 18.626 -14.4882 23.5427 -0.564853 -368 2 16.573 5.93167 0.182006 3.19594 -3.93797 2.70551 -369 2 16.4292 7.40436 18.4932 17.3888 -11.7094 -2.73385 -370 1 8.93374 7.05508 7.97597 -34.6157 -22.4872 9.48373 -371 2 9.83531 7.32727 7.97774 29.5921 7.62374 2.22252 -372 2 8.80811 6.41093 8.72029 6.54491 10.6746 -16.3243 -373 1 12.5312 0.423333 1.1911 6.44852 -9.8202 9.01884 -374 2 13.2753 0.834119 1.64897 1.63592 5.99122 -1.78887 -375 2 12.9315 0.0607692 0.396252 -6.77848 2.89528 -3.69601 -376 1 5.75537 14.98 14.4363 12.3645 2.0371 -4.21343 -377 2 4.82148 15.0687 14.6213 -16.3449 4.01416 5.01671 -378 2 6.0882 15.8478 14.162 -3.83146 3.10822 0.706071 -379 1 3.69037 6.49544 1.72037 -3.07239 6.81288 -7.41536 -380 2 3.43088 7.36249 1.36332 1.27628 -12.1507 -2.18765 -381 2 3.67848 6.67228 2.6574 4.23334 -3.71069 10.2966 -382 1 3.82256 11.2843 12.3046 -0.864415 -4.77059 0.0245619 -383 2 4.71622 11.5939 12.5181 -0.579536 5.4381 2.57712 -384 2 3.18979 11.9063 12.6819 -0.230908 7.2683 5.57723 -385 1 5.33149 3.8717 15.6726 -21.611 69.2317 6.1195 -386 2 6.02506 3.28248 15.4947 35.9646 -33.3333 -4.61122 -387 2 5.75271 4.79171 15.6869 -18.1046 -35.0984 -1.75377 -388 1 13.9893 10.0773 4.7789 22.4286 4.91544 -48.853 -389 2 14.2819 9.66907 5.58109 5.23319 -9.97863 19.9681 -390 2 14.5573 9.69868 4.0468 -17.0356 6.64649 24.2901 -391 1 7.62039 17.28 9.03644 -1.79817 -13.3385 2.54351 -392 2 6.82618 17.452 9.57294 2.68689 7.94648 -2.92213 -393 2 7.87136 18.0666 8.53956 -0.560867 8.99315 -4.02364 -394 1 4.58082 14.4709 3.89205 3.13293 1.46958 -13.0867 -395 2 4.66344 15.3386 4.31009 -0.0981131 -0.860678 2.59791 -396 2 4.56838 13.761 4.54421 -0.137719 -0.424919 8.72805 -397 1 14.11 7.4138 15.8858 20.156 9.8447 -1.08692 -398 2 14.9007 7.50898 15.3123 -12.2349 -4.78906 9.9244 -399 2 14.35 7.89712 16.7003 -4.15301 -9.39138 -6.29924 -400 1 2.88871 18.3931 1.90601 -10.0733 25.2579 5.70796 -401 2 2.56074 17.6209 1.45485 -4.97176 -8.65563 -11.6917 -402 2 2.08224 0.29716 2.10455 27.8478 -15.7521 2.2348 -403 1 8.03506 1.57584 4.43091 11.32 6.26446 5.75526 -404 2 7.34029 2.01323 3.92479 3.96785 0.109851 -4.32136 -405 2 8.88243 1.87946 4.04557 -12.5027 -7.48646 4.71123 -406 1 2.59748 14.2159 17.7933 -41.9258 1.66076 -8.0641 -407 2 1.85609 13.5734 17.9588 19.2075 16.8599 2.55802 -408 2 3.39352 13.7425 17.9784 23.6145 -16.2032 6.42715 -409 1 1.02442 1.99672 13.9281 17.4639 2.95853 -13.5386 -410 2 1.00308 1.87917 14.8709 4.63864 -6.80727 18.6653 -411 2 18.7659 2.1043 13.6716 -21.6962 3.88026 -3.66909 -412 1 4.27686 0.20187 13.9044 10.5162 4.04171 -16.044 -413 2 5.10447 18.3372 13.9403 -4.05013 6.4475 2.1433 -414 2 3.72354 18.5099 14.5979 -6.57077 -5.71295 14.511 -415 1 7.38305 1.01959 18.4815 -37.4449 7.12948 8.58409 -416 2 7.61008 0.74545 17.6036 5.58611 -6.30497 -21.5445 -417 2 6.41018 1.26146 18.4662 31.347 -10.6343 7.25927 -418 1 15.7518 18.4403 13.8831 -5.31168 6.41878 -7.08883 -419 2 14.7988 18.525 13.6912 13.3949 -2.54728 9.28792 -420 2 15.9153 18.5927 14.8217 -8.96218 -2.42265 4.9219 -421 1 10.3004 4.59906 16.2125 -26.9192 -42.5531 9.44494 -422 2 11.2318 4.75068 16.1287 26.1471 2.80018 1.93501 -423 2 10.2211 3.60629 16.3773 -0.864587 37.9812 -10.9337 -424 1 15.8848 17.7109 4.47524 -26.0192 -17.7161 -6.69824 -425 2 16.416 18.4558 4.72522 12.9982 18.1701 2.23702 -426 2 14.9575 17.9834 4.62838 14.848 -2.41832 2.25768 -427 1 6.86545 17.6577 14.0262 -6.12412 -8.41921 6.45462 -428 2 7.47866 17.6693 14.7646 2.09746 6.93436 13.8689 -429 2 7.44902 17.4838 13.2997 11.4214 -0.145135 -19.8537 -430 1 13.1703 6.41318 6.52816 -11.7529 -0.316938 -15.1514 -431 2 13.9829 6.90375 6.37155 7.88734 -3.14145 2.99861 -432 2 12.7537 6.33512 5.64174 6.34445 -4.78434 12.9923 -433 1 7.85335 2.30114 9.49646 -14.1039 1.33546 -28.6309 -434 2 7.23443 2.06415 10.1901 -3.07143 2.26257 12.1486 -435 2 7.33833 2.15664 8.66054 15.7097 0.546065 18.7565 -436 1 15.1664 14.7315 13.8676 -13.4222 3.7476 -0.777794 -437 2 14.8716 15.1233 14.7167 4.70885 -6.20173 -11.3706 -438 2 14.4912 14.9291 13.1959 7.90291 2.0321 9.20294 -439 1 9.36434 8.4507 3.85153 -5.45323 -8.44175 -9.3174 -440 2 10.195 8.80526 4.18009 6.07261 4.07641 1.89943 -441 2 9.48655 7.50041 3.73575 1.17631 -1.18483 4.07146 -442 1 17.585 13.5529 16.4533 28.0827 9.29223 -15.0932 -443 2 16.6463 13.3857 16.5308 -13.0105 5.34146 -4.98563 -444 2 17.7372 14.3421 15.8749 -12.9185 -11.1551 11.5131 -445 1 5.00344 10.4544 2.83444 15.3623 2.39709 8.30796 -446 2 5.84337 10.0047 3.04968 -12.8086 4.14038 -0.288119 -447 2 4.84487 11.029 3.60723 -3.54173 -2.25206 -8.41364 -448 1 3.64071 8.37653 9.83285 -3.63557 -2.42467 19.3481 -449 2 3.86873 9.30617 9.70655 -0.364806 7.27712 -2.43853 -450 2 3.42279 8.30417 10.789 5.82381 -0.771913 -15.5307 -451 1 16.012 6.92262 5.85834 3.10414 -0.205141 -1.95775 -452 2 16.7064 7.38617 6.35888 -2.44937 -6.94247 -7.87698 -453 2 16.3342 6.01666 5.66219 -6.01431 14.0457 5.91674 -454 1 15.3573 7.28861 8.91428 -7.73552 23.9623 -29.5509 -455 2 15.9286 7.60908 9.59449 17.6585 1.69923 20.6432 -456 2 15.3281 8.05346 8.27817 -7.4668 -29.0722 12.6462 -457 1 6.23444 12.7891 12.7562 -16.1216 7.07791 -6.67583 -458 2 7.04381 12.3675 13.028 12.7717 -9.63916 7.37694 -459 2 6.08648 13.5082 13.3891 2.20208 -1.21591 -2.77254 -460 1 12.1275 4.60499 13.1618 30.5736 27.4894 8.79026 -461 2 12.1815 4.60813 14.1323 1.45244 -2.14521 -6.91324 -462 2 11.4269 4.052 12.8891 -30.6572 -22.7655 -2.33684 -463 1 11.4418 8.05897 7.8749 4.39649 -6.11408 4.26725 -464 2 12.0054 7.38105 7.40707 -4.89778 19.9996 19.2901 -465 2 11.7913 8.23063 8.79017 -1.61454 -12.0828 -25.9053 -466 1 16.8934 10.7552 7.64898 5.958 -15.487 6.46706 -467 2 17.5218 10.034 7.45777 0.434714 4.65833 3.39608 -468 2 16.8005 11.223 6.82193 -0.787623 15.1873 -12.5781 -469 1 5.19162 18.0101 10.6182 -11.7475 -9.51575 -5.50364 -470 2 4.6689 17.2843 11.0141 12.267 13.7571 -4.22389 -471 2 4.61649 18.3258 9.88348 13.0529 -7.1725 20.3587 -472 1 7.61953 17.4141 1.49962 -5.28373 3.7131 11.8258 -473 2 8.17503 16.7132 1.19553 7.57367 -21.9054 -5.9523 -474 2 7.57614 18.0024 0.755384 -3.403 20.0604 -6.05803 -475 1 1.93154 12.9424 13.6297 4.26026 1.62766 0.165619 -476 2 1.31807 12.4855 14.2164 3.08324 -4.19991 0.575461 -477 2 2.34989 13.6289 14.1741 -4.48691 2.36366 -2.57882 -478 1 9.34851 6.7636 14.8211 -2.90069 2.43692 -15.7898 -479 2 9.659 5.88476 15.1078 3.08688 5.56829 -7.87962 -480 2 9.50722 6.89182 13.8456 0.484936 -6.74561 22.7152 -481 1 15.2631 4.37275 10.7209 -0.391742 -1.67154 5.71992 -482 2 16.1506 4.03655 10.897 1.37527 -0.677682 -8.66997 -483 2 15.1154 4.97006 11.4686 -2.24536 -2.27818 -6.11794 -484 1 11.4934 6.22632 -0.0241442 -6.06296 -11.7718 -8.66306 -485 2 11.6483 5.30933 -0.309107 4.27028 6.28431 2.83608 -486 2 10.5284 6.3165 18.5406 6.28072 6.83613 2.73886 -487 1 18.4725 11.4275 14.8977 -1.36673 1.10287 -33.3787 -488 2 18.0559 11.937 14.1605 1.63397 -11.827 9.6186 -489 2 18.3384 12.0011 15.6307 -5.5196 20.2825 24.8766 -490 1 7.17852 9.29091 7.31266 -12.1778 -5.70725 -5.55247 -491 2 6.76293 8.42612 7.50122 5.49043 12.248 4.67896 -492 2 8.1168 9.11866 7.26453 10.5183 -1.31775 0.108346 -493 1 18.3399 15.3762 12.1294 6.77425 7.85663 0.444206 -494 2 0.624383 15.5788 11.9067 -6.5428 -1.83873 1.38378 -495 2 17.7957 15.9125 11.5264 -1.63248 -5.99386 0.103645 -496 1 16.5386 4.34911 5.2503 -38.2238 -21.0357 51.9327 -497 2 16.6701 3.96728 6.16388 -6.69454 12.6485 -26.055 -498 2 17.3775 4.32019 4.85382 41.1543 5.3392 -22.1831 -499 1 17.7341 3.08223 10.7755 -2.39486 19.3144 10.8573 -500 2 18.6554 3.32717 10.9901 -9.67157 -6.39923 -2.68969 -501 2 17.7406 2.18791 10.4534 3.10102 -17.6187 -9.33289 -502 1 12.3347 18.6584 10.1394 22.1152 -18.6094 -11.1242 -503 2 11.4269 0.285024 10.28 -5.50333 15.1479 5.74269 -504 2 12.9381 0.769801 10.2484 -7.53185 0.18177 2.36971 -505 1 10.4414 9.72052 12.5804 5.49259 18.5488 2.65475 -506 2 11.2372 9.86145 13.1232 -3.33328 -5.81976 -2.33485 -507 2 10.4983 8.8205 12.2639 -0.9125 -13.8337 3.2089 -508 1 0.576047 2.60181 7.2501 -1.65995 13.3288 -12.3458 -509 2 0.268028 3.48996 7.49944 2.28387 -7.91724 -1.96879 -510 2 1.05133 2.26453 8.01425 -2.57801 -1.32252 3.73717 -511 1 0.35756 15.2681 6.96461 -6.18578 -18.242 -64.2832 -512 2 0.656709 14.9904 7.8095 9.46814 -3.47663 35.1726 -513 2 0.533918 14.474 6.37104 -3.56161 26.9089 25.8891 -514 1 17.0554 6.8805 14.912 24.4713 -1.83906 11.5387 -515 2 17.8121 7.50971 14.9246 -13.4777 -6.95308 -2.51376 -516 2 17.3666 6.12061 15.452 -8.01529 8.59931 -8.57008 -517 1 9.11821 12.4896 7.9597 -39.3936 14.7629 -4.46817 -518 2 9.45619 11.6923 7.5591 7.68398 -14.1787 -12.8233 -519 2 8.20522 12.6235 7.56541 34.2702 -5.52337 13.9854 -520 1 1.14934 1.62531 2.7512 -10.6975 -16.4856 11.3042 -521 2 0.557887 1.95566 2.07466 1.95024 15.5996 -8.59751 -522 2 1.5216 2.35039 3.25303 6.14281 9.13632 1.51194 -523 1 4.18801 15.1235 9.83797 -4.3571 13.9944 -8.49019 -524 2 4.15169 15.4364 8.91421 -7.63033 -5.74015 13.5827 -525 2 5.04261 14.6826 9.83518 3.69587 -3.91806 9.7151 -526 1 7.38616 2.29059 14.8987 -4.38475 3.80451 -15.2317 -527 2 7.23636 1.51405 14.3418 -1.55041 0.530275 6.25745 -528 2 7.45512 3.02747 14.2682 8.09838 -6.66607 2.4433 -529 1 18.2954 14.5248 2.13868 21.7335 16.5649 1.154 -530 2 0.530315 14.9412 2.32201 -13.6123 -15.8317 -3.76049 -531 2 17.7186 15.2797 1.96871 -6.10103 1.83177 1.59348 -532 1 10.0818 2.68123 12.8993 0.213282 -13.011 -16.4533 -533 2 9.9804 2.00538 12.1749 2.58274 17.6757 17.7308 -534 2 9.30115 3.24961 12.8455 -1.77409 -0.0668197 -1.90377 -535 1 2.92042 8.79199 13.1038 3.60331 12.5418 -6.85933 -536 2 3.19747 9.71233 12.8787 -2.51528 -19.5049 2.84802 -537 2 3.74925 8.3139 13.2755 -6.12566 -1.47569 1.35688 -538 1 3.2826 8.6043 3.78787 -1.06696 -30.5523 53.3514 -539 2 3.6648 9.24286 3.23576 21.5217 31.7748 -30.2126 -540 2 3.73659 8.75462 4.6619 -18.3855 -4.45548 -24.3241 -541 1 5.99503 7.23605 8.68049 -5.70462 -6.01689 -7.52618 -542 2 5.88732 6.32464 8.37432 -5.09887 -1.13221 5.21957 -543 2 5.15444 7.50455 9.08765 4.58913 -3.02319 1.70333 -544 1 14.8694 1.67632 1.824 4.95495 -3.07302 -21.4612 -545 2 14.923 2.54765 2.20438 -6.9063 6.82762 18.8127 -546 2 15.1986 1.83723 0.92353 -1.55356 -7.84532 7.79991 -547 1 8.71318 14.9586 0.633889 5.3189 4.72704 12.5337 -548 2 9.41548 15.0137 1.3229 -12.9747 -8.59069 -7.21106 -549 2 7.9574 14.4505 1.00218 9.17218 5.81258 0.251254 -550 1 15.3522 1.50057 7.22863 -1.61242 -14.2743 -3.26221 -551 2 14.7819 0.961058 6.63945 7.54361 11.5891 10.8038 -552 2 14.804 2.18796 7.6304 -1.95204 4.928 -5.75504 -553 1 4.88832 12.8638 18.4669 14.1773 6.076 10.5021 -554 2 5.16486 12.9634 0.754115 -2.57074 -3.9589 -10.7447 -555 2 5.64539 13.2163 17.9734 -6.87045 1.01425 -0.872896 -556 1 15.3658 8.71105 18.1022 0.313753 1.99863 -15.4271 -557 2 15.6825 9.25538 17.3367 -2.33671 -6.91366 23.9636 -558 2 15.2177 9.29821 0.21527 -1.89476 6.92048 -0.597105 -559 1 12.0025 3.14868 18.2874 -4.08601 9.85731 -2.22671 -560 2 12.1144 3.11564 0.603374 4.33643 -8.86024 -4.9595 -561 2 12.4653 2.40747 17.863 0.0624807 -1.52737 7.22507 -562 1 13.2135 12.7035 5.12884 9.73413 0.384952 2.90661 -563 2 13.7 11.8654 5.00774 -9.98906 4.00813 0.0328844 -564 2 13.4141 12.9701 6.04548 -3.79483 -4.91087 -6.97232 -565 1 6.18903 7.09371 0.234798 3.60985 -26.8596 -14.0682 -566 2 6.2071 8.04594 18.8061 -7.0012 19.4313 6.00448 -567 2 5.26363 6.79856 0.279731 4.49735 8.94005 5.55961 -568 1 17.7003 15.89 14.853 -18.1963 11.2058 -20.3772 -569 2 16.8346 16.3247 14.8039 6.19322 -4.54728 12.6057 -570 2 17.8435 15.7325 13.9057 13.4875 -6.37623 4.18836 -571 1 13.0834 0.870867 16.8965 -0.161813 1.3846 -1.86612 -572 2 14.0072 0.582211 16.892 1.10768 1.72224 0.871652 -573 2 12.5754 18.726 16.653 1.71204 -0.315799 1.62538 -574 1 10.8945 14.507 7.48359 31.9827 12.7774 -14.5262 -575 2 10.2535 13.8684 7.76101 -18.1255 -14.8352 9.6937 -576 2 11.748 14.0397 7.49435 -7.74827 -1.48019 1.36014 -577 1 17.7521 8.40099 2.11802 -4.68381 10.101 13.2464 -578 2 16.8759 8.32923 2.50971 -7.38706 6.94009 5.95596 -579 2 17.7532 7.67887 1.5098 2.25561 -17.6604 -22.6471 -580 1 12.5231 7.84865 2.0094 -2.30264 15.9804 1.37474 -581 2 12.1379 8.74758 1.97393 9.3167 -10.0751 -1.70323 -582 2 12.325 7.4571 1.14918 -4.66948 -5.90928 2.89896 -583 1 11.972 14.5025 10.3451 -2.96888 12.9379 -2.77484 -584 2 12.1874 14.7132 9.42348 -1.74009 -6.18971 10.5862 -585 2 11.0277 14.706 10.4449 2.87573 -2.36207 -4.30421 -586 1 6.71227 6.84952 15.5806 25.6498 -3.78319 22.6581 -587 2 7.68828 6.90632 15.3859 -23.8939 0.442938 5.1849 -588 2 6.62279 7.02219 16.5478 -0.830995 -1.23763 -22.0679 -589 1 7.92027 4.40739 13.1357 7.88731 17.7005 28.4833 -590 2 7.20639 4.70613 12.563 -5.96959 3.19417 -4.54574 -591 2 8.05118 5.13552 13.7952 -2.84521 -16.8776 -20.7331 -592 1 13.2899 12.2294 14.3537 -3.3223 6.18653 6.3482 -593 2 12.9901 11.3268 14.1873 4.87208 -4.78833 3.90165 -594 2 13.6879 12.5058 13.5223 1.91273 0.0234059 -4.06458 -595 1 14.5389 9.51264 7.32918 -7.01434 -27.1539 -11.6023 -596 2 15.2763 10.0624 7.53312 20.4851 16.6908 8.43718 -597 2 13.8132 9.80854 7.861 -14.3264 8.19434 11.2695 -598 1 12.68 16.8773 3.29092 2.11558 25.6431 -8.94229 -599 2 12.7733 17.3894 4.13219 -1.2803 -9.72294 -18.9636 -600 2 12.6793 17.5234 2.53176 -0.650571 -10.0569 23.6182 -601 1 0.970813 7.05439 17.3478 19.6691 8.71735 -9.44801 -602 2 0.0997442 7.2771 17.6294 -27.888 -7.65058 15.2547 -603 2 1.07493 7.61203 16.5711 5.30897 3.90939 -5.98442 -604 1 13.0218 4.86702 15.7977 -14.5255 -22.5737 -0.430567 -605 2 13.6652 4.12206 15.7771 -2.73243 23.3382 0.768668 -606 2 13.4898 5.70142 15.8866 10.098 7.61534 -0.732483 -607 1 2.35004 3.40025 5.07686 -12.6408 -17.529 -7.45963 -608 2 1.84891 3.15034 5.87751 4.27568 5.0167 -3.29201 -609 2 2.74325 4.26374 5.21682 1.23402 6.29722 12.7184 -610 1 8.14417 10.9001 13.7499 9.28616 -30.1931 45.6744 -611 2 7.9506 10.3552 14.611 8.46781 36.9232 -44.8577 -612 2 9.00813 10.5574 13.4404 -10.6035 2.99953 -2.14266 -613 1 13.0821 1.49083 13.2989 5.3891 9.28887 -24.1834 -614 2 13.7872 1.3627 12.5959 -25.8284 12.5052 17.3021 -615 2 12.4896 2.22352 12.9857 19.0093 -19.6589 8.86348 -616 1 6.62484 13.6674 2.02561 -2.30013 1.61314 -5.1998 -617 2 5.94206 14.1599 2.51404 7.05284 -6.38204 5.2583 -618 2 7.12137 13.1184 2.65568 -4.11309 1.61678 2.96157 -619 1 15.7857 6.33001 12.4874 9.47505 -1.37582 18.5865 -620 2 16.2809 6.76838 11.7933 3.97273 7.7159 -2.96061 -621 2 16.3586 6.41799 13.2831 -12.689 -0.09302 -8.30077 -622 1 16.7471 0.613682 9.52771 11.5447 -14.6629 17.7173 -623 2 16.7567 18.2848 9.57147 -3.7535 4.88819 4.87116 -624 2 16.43 0.840462 8.66213 -13.2327 5.78697 -22.1845 -625 1 6.19152 11.681 8.24955 3.80355 -8.99636 -2.81467 -626 2 5.36879 11.4903 8.73023 3.19436 -10.2741 -4.0588 -627 2 6.55865 10.8405 7.8788 -10.8203 9.76695 14.653 -628 1 2.78766 8.56788 0.409413 -52.7319 2.11899 -11.855 -629 2 2.08185 8.03903 18.552 32.3713 20.2249 14.5342 -630 2 2.26775 9.27739 0.866586 13.6595 -12.5773 -9.56289 -631 1 10.1003 10.2385 6.61376 -10.8952 5.58665 6.62413 -632 2 10.4921 9.47201 7.04387 8.70092 -2.05853 1.95229 -633 2 10.597 10.3787 5.79806 -1.31095 -2.00825 -0.431677 -634 1 6.84539 15.7603 6.76774 -1.32488 -8.5888 0.285168 -635 2 7.15445 16.2386 7.5582 -1.07119 -0.859265 -6.52036 -636 2 7.16186 16.249 5.99512 -0.908646 8.8198 -0.167177 -637 1 6.64088 12.8596 5.99362 6.27305 7.11444 -12.0385 -638 2 6.74407 13.8044 6.07603 1.27228 12.7365 2.69296 -639 2 6.25078 12.5941 6.82297 -5.96354 -7.18103 4.5408 -640 1 16.6867 12.5722 9.84379 -3.64815 -5.06409 7.40683 -641 2 16.7505 11.8965 9.15556 3.82735 1.49832 -4.74998 -642 2 16.8024 13.43 9.4304 0.212763 1.2752 -2.86494 -643 1 6.31521 2.74143 2.73106 -6.87016 -8.03266 -4.4066 -644 2 6.55003 3.64872 2.52358 -0.655364 10.9132 -0.0341781 -645 2 5.98199 2.35933 1.9027 -1.39596 -0.0669143 5.2552 -646 1 10.642 2.89265 3.25205 -8.44131 -1.48195 -5.66324 -647 2 10.1183 3.68518 3.4139 4.92295 3.00907 1.37692 -648 2 10.2968 2.53281 2.41595 2.77965 2.00448 3.56419 diff --git a/examples/amoeba/dump.water_box.hippo.1 b/examples/amoeba/dump.water_box.hippo.1 deleted file mode 100644 index 33463a3a5d..0000000000 --- a/examples/amoeba/dump.water_box.hippo.1 +++ /dev/null @@ -1,7227 +0,0 @@ -ITEM: TIMESTEP -0 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.67966 7.08769 17.9461 -19.3527 -13.639 6.25201 -2 2 7.80945 6.75579 18.2607 18.4949 11.1596 -6.01922 -3 2 8.72223 6.81424 17.0254 5.85599 -0.890166 3.45586 -4 1 18.5257 8.24445 6.83762 11.8085 12.5587 58.8481 -5 2 0.216892 7.89544 6.05003 10.8935 -14.9684 -50.5046 -6 2 0.444268 7.82601 7.5302 -15.2958 7.9793 -8.89884 -7 1 8.37906 18.5504 6.81463 25.5385 6.64228 -3.75624 -8 2 9.34042 0.098069 6.73406 -20.9151 -2.68951 1.38711 -9 2 7.93962 0.573676 6.26984 -0.656308 -0.308718 3.40946 -10 1 6.58995 1.84432 11.7198 46.6828 -15.9611 -12.5859 -11 2 5.88543 2.40231 11.9251 -37.6261 28.8114 18.1934 -12 2 6.18153 1.06275 11.3693 -6.58868 -16.6156 -5.55691 -13 1 7.1466 5.75358 2.33152 -56.1364 42.5085 -2.61462 -14 2 6.36812 6.12603 2.86268 40.1937 -23.4301 -4.21826 -15 2 7.02502 6.29465 1.5182 16.3021 -20.7884 10.9258 -16 1 16.2164 10.1388 16.1382 -32.0875 21.5958 16.7579 -17 2 16.9509 10.2747 15.5847 32.9015 -1.03241 -20.1636 -18 2 15.8498 11.0405 16.2399 1.98783 -14.756 2.71439 -19 1 10.6046 15.0374 2.30369 -8.13409 -25.494 -7.18668 -20 2 10.5292 14.3949 3.01849 1.41683 -0.603724 2.75561 -21 2 11.0236 15.78 2.70962 11.6057 19.8833 4.5888 -22 1 17.1624 8.24409 10.3708 13.0676 7.07862 9.73504 -23 2 16.5528 8.68798 10.966 -4.65968 7.37974 1.83434 -24 2 17.9421 8.82333 10.3208 -6.34155 -10.1937 -2.20396 -25 1 14.901 15.8652 16.3167 18.01 -6.87509 18.5636 -26 2 14.0225 16.1982 16.2525 -26.9236 12.7201 -6.50875 -27 2 14.9141 15.482 17.2099 2.63751 -6.05913 -7.59706 -28 1 12.1752 13.3771 0.408263 -11.3168 6.26442 9.98381 -29 2 12.0579 13.8465 18.23 5.67057 -4.50268 -16.0578 -30 2 11.6217 13.8904 1.00796 3.42507 -1.00312 9.73088 -31 1 9.27358 5.34243 4.05546 -35.2781 32.5984 16.8393 -32 2 8.64594 5.4665 4.83764 28.3783 -16.8163 -28.778 -33 2 8.74177 5.68615 3.30282 7.52493 -14.9247 9.48156 -34 1 1.83016 4.27673 11.6495 -21.1764 37.5598 -8.14901 -35 2 1.70328 5.22377 11.9391 6.02814 -28.7768 -8.29565 -36 2 2.40811 3.85345 12.2597 13.4728 -11.3181 18.3421 -37 1 1.96438 6.83299 8.3731 -11.1902 3.43717 -25.3738 -38 2 2.49614 7.21578 9.0563 9.35281 -0.190165 18.6039 -39 2 1.81128 5.90585 8.57354 7.84101 -3.79534 5.21373 -40 1 5.40557 4.38899 7.93274 -6.81526 4.7224 -2.63907 -41 2 5.53738 3.43895 7.78131 -7.79962 9.88898 0.533881 -42 2 4.75516 4.73491 7.29062 10.7858 -16.238 7.24535 -43 1 3.23 2.92842 17.5524 -0.538114 20.9936 16.7312 -44 2 3.93109 3.19827 16.9402 -0.965509 8.21721 4.01649 -45 2 3.00444 3.70897 18.1497 6.13449 -29.114 -23.6081 -46 1 7.4624 5.26283 6.13117 9.12728 4.25284 -1.73168 -47 2 8.02565 5.58849 6.88177 -24.817 -14.4341 -14.6054 -48 2 6.93508 4.45577 6.3254 16.0496 22.0303 12.0173 -49 1 9.77896 7.02384 11.9834 11.1205 -3.87253 23.9446 -50 2 10.2721 6.37256 11.5011 10.9222 -10.0302 -1.39678 -51 2 9.1532 7.31587 11.3499 -23.6433 13.1239 -20.7784 -52 1 14.1167 3.54999 8.03003 -30.7601 -1.60704 -37.9113 -53 2 13.4732 4.22413 7.73132 15.1608 -10.723 4.30178 -54 2 14.3809 3.80189 8.88487 12.8065 16.1495 34.678 -55 1 4.82329 17.2568 4.03846 -17.85 32.0436 -31.4073 -56 2 5.49315 17.973 4.01308 -7.71314 -24.6342 10.4391 -57 2 4.18746 17.5412 3.33843 10.9703 -13.5421 12.8553 -58 1 16.4918 16.6259 10.0493 29.9016 15.3745 -40.7533 -59 2 16.1673 16.3226 10.8594 -24.6786 -13.0437 37.8908 -60 2 15.9925 16.2084 9.33562 -4.01544 -1.82242 7.63759 -61 1 1.94489 4.93323 0.49791 29.1886 10.4759 3.59715 -62 2 2.55322 5.26335 1.2053 -17.2324 -10.4098 -15.9422 -63 2 2.08253 5.591 18.4408 -14.7087 -3.80383 3.81857 -64 1 11.816 13.3571 16.2711 -7.8083 1.12937 6.2001 -65 2 11.2371 12.6203 16.5671 13.3708 1.96491 -16.2063 -66 2 12.2446 13.1893 15.4079 -11.197 -7.32732 11.8633 -67 1 10.105 11.0651 16.9545 16.7158 -32.7784 1.37979 -68 2 10.5674 10.1947 17.1295 -14.0823 30.097 -5.45833 -69 2 9.25349 10.8067 16.5912 -2.99511 2.11526 2.57572 -70 1 11.7264 17.5421 13.4742 2.50122 -25.0158 -11.214 -71 2 12.2771 16.9836 12.8968 -8.91486 0.79877 6.23222 -72 2 12.1041 18.3936 13.317 1.59091 22.4782 2.42571 -73 1 6.33029 9.31911 12.2264 15.6898 -25.4439 -25.1534 -74 2 7.02603 8.96242 11.6353 -17.823 2.07037 1.33758 -75 2 6.81249 9.95941 12.7172 5.93051 22.1649 19.4162 -76 1 16.2187 12.7249 2.70186 -8.69715 -37.3569 7.82337 -77 2 17.0292 13.1566 2.50302 19.6243 18.7999 -9.68795 -78 2 15.4982 13.3357 2.61812 -8.61102 21.6356 1.57727 -79 1 0.637202 12.5625 5.84914 -32.6687 7.10288 -2.13707 -80 2 0.892312 12.5507 4.90771 -4.51242 -1.40786 13.4578 -81 2 18.3039 12.804 5.85329 37.5994 -4.88925 -6.97833 -82 1 5.19922 16.3781 18.5047 -7.71264 -0.634541 -12.9921 -83 2 5.80284 15.8543 17.9455 2.11468 10.7978 13.7187 -84 2 5.67034 16.9636 0.462296 7.23142 -5.58048 -3.24093 -85 1 0.510145 7.62945 4.0545 45.851 19.5686 -25.4796 -86 2 18.5719 8.14656 3.45296 9.61971 -16.7838 10.3831 -87 2 1.46496 7.74082 3.66917 -52.3954 -1.94356 25.3273 -88 1 3.14672 8.89584 6.52626 -54.2957 5.34018 -1.73828 -89 2 3.50609 8.59991 7.35294 9.18701 -2.26398 8.55435 -90 2 2.14573 8.92962 6.68203 45.3688 -0.563656 -9.64228 -91 1 7.30854 10.3037 16.1717 -0.0267506 0.140778 15.7468 -92 2 6.56213 10.4624 15.5802 1.32412 -0.384411 10.7132 -93 2 6.99303 10.278 17.1118 0.130505 3.94788 -23.0495 -94 1 11.1122 1.06968 4.98939 -2.83136 -16.8604 13.0177 -95 2 11.0776 1.97142 4.64864 2.2702 -4.31387 -11.6367 -96 2 10.7048 0.433547 4.37027 2.96408 14.9419 -2.56144 -97 1 4.45204 2.70061 13.2052 -8.32298 -31.9478 35.5434 -98 2 4.60333 3.05865 14.0914 -0.476624 15.5497 -15.2927 -99 2 4.38645 1.737 13.4626 0.207127 24.1129 -25.2696 -100 1 8.42792 10.0237 1.78469 -10.6267 -17.9408 16.848 -101 2 8.3405 10.6377 2.53622 4.43246 -2.98222 -4.40025 -102 2 8.49672 9.11244 2.17467 4.60711 29.3182 -9.45134 -103 1 10.5335 1.75383 15.546 -31.9958 -1.22726 0.532554 -104 2 11.3977 1.82718 15.9216 23.4057 -5.242 -0.0927752 -105 2 10.5608 1.78317 14.5837 3.34522 3.38855 0.282019 -106 1 2.77693 12.941 7.74821 -10.6415 2.34425 -2.27994 -107 2 3.28797 13.5733 7.23382 5.58977 0.334345 4.09149 -108 2 1.98704 12.8256 7.20013 5.22386 -8.52712 2.54059 -109 1 3.63517 11.6895 5.33963 -10.2259 -13.0028 -10.3717 -110 2 3.35385 11.0502 6.03137 4.73753 15.317 -16.6328 -111 2 2.8758 11.855 4.74058 11.3048 -4.09559 12.5928 -112 1 6.88803 14.474 16.8428 -13.42 9.46677 6.94107 -113 2 7.55973 13.8293 16.6383 4.5229 -1.76969 -1.40507 -114 2 6.60381 14.8838 16.0165 0.0834179 -9.06129 -0.120708 -115 1 14.1722 14.5374 3.41536 20.1951 -3.19134 -21.8839 -116 2 13.6514 15.2845 3.14096 -9.23852 13.3738 0.77613 -117 2 13.8512 14.2508 4.25439 -13.5451 -9.47926 16.7085 -118 1 8.28226 18.1809 16.0824 -9.43856 -15.6135 -5.07226 -119 2 8.77677 17.3494 16.3071 1.43839 31.5077 -5.33478 -120 2 8.7603 0.384816 15.9919 11.1327 -19.5096 4.24776 -121 1 4.73724 1.61643 4.90111 5.86874 37.6921 -30.6753 -122 2 3.96969 2.16837 5.15263 9.12039 -10.9712 -6.28456 -123 2 5.18465 2.1484 4.15475 -17.6049 -26.8232 41.7187 -124 1 15.1457 12.8616 16.4403 -17.0638 -11.2899 43.408 -125 2 14.6041 12.8692 17.2613 22.7365 8.03356 -12.6578 -126 2 14.49 12.6307 15.8136 -17.0236 -4.89604 -35.7974 -127 1 15.779 18.3837 16.786 48.5063 8.0766 44.3104 -128 2 16.5108 18.615 17.4688 -41.9285 -7.99937 -34.0327 -129 2 15.7694 17.4186 16.7687 -10.3466 2.2793 -1.1406 -130 1 1.1383 1.1331 16.5571 -3.54071 10.9478 5.94974 -131 2 1.96551 1.50352 16.9177 -15.9767 0.55296 -3.51275 -132 2 0.420521 1.53444 17.0916 21.5279 -7.8795 -5.43288 -133 1 18.0817 4.5907 15.863 15.8138 -19.1991 -2.64562 -134 2 18.5818 3.91936 15.3489 -11.6552 16.5822 9.8521 -135 2 18.5602 4.7339 16.6874 -1.16116 -1.56098 -3.02727 -136 1 12.22 16.9378 16.1148 -9.97587 -12.4224 57.0196 -137 2 11.409 16.6934 16.6676 29.0172 6.05041 -31.7989 -138 2 11.9646 17.3216 15.2917 -14.4882 2.9648 -22.1743 -139 1 15.8709 2.55221 17.9707 -3.56258 26.452 -16.7944 -140 2 15.7355 3.48355 18.2574 6.35046 -25.5765 3.86241 -141 2 15.6659 2.59235 17.0072 6.0189 -6.56803 19.8103 -142 1 6.70868 13.791 10.2637 1.94011 22.9489 3.02058 -143 2 6.59347 13.548 11.1958 0.710608 -4.45224 -7.92394 -144 2 6.58252 13.0514 9.6765 -3.73143 -16.591 0.344408 -145 1 10.146 18.2027 2.80372 16.894 35.9 -12.6825 -146 2 10.2207 0.331961 2.18345 -1.03174 -23.6422 14.9845 -147 2 9.26571 17.8868 2.67703 -18.7462 -7.34721 -7.1199 -148 1 2.97538 17.748 6.06078 -27.2244 1.77787 1.96995 -149 2 2.09399 17.6473 5.67013 1.23544 -3.46851 16.5241 -150 2 3.45883 17.8838 5.26396 32.1509 0.10025 -8.47089 -151 1 12.558 17.0134 7.97028 2.72879 -14.1128 -3.91884 -152 2 11.9572 16.2512 7.82085 4.20569 13.3061 15.6125 -153 2 12.4657 17.4524 8.83591 -10.4039 -6.95813 -9.08653 -154 1 14.8795 15.2862 8.28544 5.56082 -19.5077 38.9848 -155 2 13.9824 15.6136 8.40666 -1.04882 8.68143 -14.5015 -156 2 15.2312 15.4641 7.43118 2.2507 10.8701 -29.8329 -157 1 17.5429 18.3228 0.375372 -51.3852 -2.4253 -14.1847 -158 2 18.116 17.6308 0.128652 38.5367 -21.5025 -8.63787 -159 2 17.9698 0.288559 0.934677 24.3068 21.4661 19.9837 -160 1 0.910209 10.3712 1.41143 -2.71779 -52.992 43.3073 -161 2 0.158544 9.88347 1.87089 22.0109 19.7614 -26.7074 -162 2 0.565924 11.0969 0.944383 -22.7833 34.6337 -23.5778 -163 1 1.55407 12.175 3.31087 16.6578 22.9783 50.8488 -164 2 1.36245 11.4802 2.72234 -7.70692 -21.3552 -33.2695 -165 2 1.61623 13.0206 2.87285 -0.913798 3.83337 -14.7861 -166 1 0.543127 17.2543 4.88609 29.8094 34.6465 -52.7559 -167 2 0.11032 17.9772 5.31124 -19.8915 12.2203 12.8491 -168 2 0.420366 16.4266 5.2673 -10.0988 -43.8479 36.8786 -169 1 1.10053 1.01949 9.38768 20.7334 -4.84081 3.89797 -170 2 1.46081 0.575286 10.1589 7.03147 5.77442 11.7732 -171 2 0.265613 0.594128 9.34525 -29.6063 -3.3853 -10.3011 -172 1 16.8007 2.32783 13.2877 6.1037 15.2386 -31.0559 -173 2 17.0701 2.57314 12.3549 -10.0746 -10.076 30.4228 -174 2 16.4263 1.43993 13.282 1.60122 -3.62923 0.222317 -175 1 2.45231 15.8283 12.1942 27.8718 -10.8871 18.2649 -176 2 2.8623 15.5513 13.0537 -9.1784 7.03247 -27.4702 -177 2 2.91392 15.3801 11.4615 -3.34054 6.42182 7.24567 -178 1 16.435 15.531 5.9458 21.7194 38.3058 -21.2998 -179 2 17.3808 15.5177 6.20547 -16.0791 -6.59953 3.69269 -180 2 16.4147 16.2211 5.22063 -10.9707 -19.0563 26.084 -181 1 5.84547 5.02056 11.8065 15.5941 -20.7973 -13.2046 -182 2 5.55799 5.91374 11.8891 -11.5246 18.633 11.9833 -183 2 5.09 4.45915 11.9819 -3.94875 -1.81326 3.16792 -184 1 15.2214 4.86555 0.731755 -13.7826 -16.8748 28.0949 -185 2 14.6776 4.45845 1.47821 23.1081 18.7106 -26.9415 -186 2 14.6696 4.95834 18.5986 -11.4435 4.17379 2.92627 -187 1 16.3401 16.2933 2.11217 18.5695 -12.4905 -31.3072 -188 2 16.0666 16.7695 2.87319 -12.4192 21.1701 22.1863 -189 2 16.7601 16.9279 1.50378 -10.9162 -1.12869 10.7347 -190 1 0.305885 4.87877 3.79118 -7.51195 53.5881 20.4451 -191 2 0.299338 5.85541 4.09758 -3.10789 -46.5114 -24.0825 -192 2 1.16991 4.5635 4.03062 6.84312 -11.1831 1.05233 -193 1 2.92501 14.9782 15.0356 -4.41813 7.08234 41.1019 -194 2 3.0159 14.7264 15.9987 0.986861 -4.57119 -32.7424 -195 2 2.35392 15.7535 15.1247 6.41577 5.11218 -9.25191 -196 1 1.1115 14.5727 9.55731 53.3594 20.601 -11.7192 -197 2 2.08491 14.4157 9.46275 -24.0912 20.2308 -9.17401 -198 2 0.897072 13.7408 9.90248 -29.0631 -35.5955 19.1061 -199 1 13.6501 16.6688 11.5433 6.78983 17.7214 -9.74398 -200 2 13.4697 17.4567 10.9694 -2.9322 -22.903 16.7504 -201 2 13.5721 15.8897 10.9842 -10.359 0.342192 0.0202177 -202 1 4.73098 1.47842 0.720986 -5.29759 -7.25447 0.0447572 -203 2 4.27169 1.98826 0.034225 -5.56193 -3.14325 9.7343 -204 2 4.11741 0.788607 1.06182 6.25861 16.2271 -3.37713 -205 1 1.42158 18.4663 11.9139 -14.0127 27.0043 -17.9914 -206 2 1.21766 0.394331 12.6648 1.7087 -1.58128 0.41261 -207 2 1.94844 17.765 12.2423 13.0376 -22.9613 11.2697 -208 1 11.5498 10.1018 4.11619 27.4262 20.5676 -21.0421 -209 2 11.5687 10.5955 3.24216 -3.20948 -18.7647 28.9446 -210 2 12.4899 10.1059 4.45555 -29.515 -1.53007 -14.7279 -211 1 8.38254 12.182 3.76573 -26.3924 1.04105 6.81072 -212 2 9.25863 12.501 4.06076 -19.5654 3.48754 6.33549 -213 2 7.63736 12.4251 4.40785 41.4561 -5.4387 -17.0092 -214 1 14.3228 4.03714 3.29709 11.5996 0.889358 18.0886 -215 2 14.8928 4.14179 4.10547 -12.6664 -0.432988 -23.901 -216 2 13.4701 4.45558 3.48891 5.46089 -2.24129 3.2962 -217 1 5.58188 1.78199 7.50513 -33.666 -46.5708 42.0626 -218 2 5.0172 1.13958 8.12095 34.1345 40.5367 -42.64 -219 2 5.33078 1.59122 6.59529 1.4651 -1.13721 -3.53311 -220 1 17.9086 1.12503 4.88467 5.13037 -2.27617 -10.7476 -221 2 18.4038 1.54032 4.14207 -7.55128 -2.38968 19.1857 -222 2 17.6814 1.78344 5.55455 5.62983 -0.00428508 -6.93418 -223 1 6.83101 9.39303 4.49716 -12.9019 3.06885 -29.4929 -224 2 6.83675 9.57499 5.42715 5.2276 -1.57178 18.8103 -225 2 7.66807 8.99049 4.24996 8.60683 3.06936 7.19189 -226 1 2.71406 14.9654 1.962 -12.6433 -7.2797 -26.4735 -227 2 3.33343 14.7912 2.66354 11.3685 -5.36414 4.18623 -228 2 3.09502 14.6645 1.10257 -3.50464 10.9487 24.1748 -229 1 17.279 12.8803 13.1283 -18.5839 20.1434 9.0108 -230 2 16.4044 13.2339 13.3283 -9.51346 -21.2442 0.20606 -231 2 17.6948 13.7346 13.0834 29.6252 3.29486 -10.2855 -232 1 15.0196 10.5818 1.38314 -38.8036 -34.5801 -31.952 -233 2 15.5102 11.1963 1.85791 33.5109 39.8843 28.1173 -234 2 14.3351 11.0964 0.933298 4.14202 -6.46403 5.49191 -235 1 5.71789 6.95838 4.52856 4.11089 -29.6335 9.96606 -236 2 5.85266 7.87985 4.34179 3.17266 16.1428 1.23553 -237 2 6.44364 6.70841 5.13514 -12.5329 -0.461157 -7.94794 -238 1 8.12142 8.26262 10.159 -0.855146 6.49391 46.4818 -239 2 8.58519 8.93965 9.66877 4.4396 1.59282 -10.2318 -240 2 7.56021 7.74854 9.59836 -7.32825 -5.6782 -22.3885 -241 1 13.5311 18.2901 5.8079 -14.4364 -13.815 12.5854 -242 2 12.703 0.102298 5.56963 8.23181 2.14052 6.61043 -243 2 13.2939 17.6289 6.50758 2.60691 23.7973 -17.1373 -244 1 0.327324 2.56344 0.113251 2.62118 15.3541 1.11187 -245 2 18.009 2.52214 18.5736 10.3638 17.1812 4.70476 -246 2 0.724331 3.48299 0.160564 -23.8753 -26.7718 -0.881277 -247 1 12.6396 10.9599 9.76875 -60.0152 14.8867 -10.4701 -248 2 11.6552 10.7306 9.75031 40.0232 26.8927 -4.84212 -249 2 12.944 10.1383 10.0842 28.9404 -31.8014 10.6031 -250 1 0.789377 12.2851 11.08 12.3121 4.77193 16.7259 -251 2 18.4919 12.3017 11.2021 -18.2956 -1.72231 -7.06107 -252 2 1.09088 12.7637 11.8722 5.11265 -11.1183 -7.6011 -253 1 5.04567 7.2193 13.4912 -20.9717 -2.87687 -14.2941 -254 2 5.59899 7.84649 13.0247 8.94565 11.9067 4.64647 -255 2 5.48047 6.97898 14.3058 11.2978 1.34955 6.76892 -256 1 1.28609 6.99027 11.837 -50.3798 -70.0072 -12.7986 -257 2 0.481329 7.14037 11.2978 16.1889 0.462756 10.6855 -258 2 1.71601 7.79102 11.8803 28.8555 60.7949 7.07409 -259 1 15.4442 9.46712 12.3088 17.5488 35.5581 30.8368 -260 2 15.6103 10.4448 12.4444 -11.4156 -32.7422 -13.7105 -261 2 15.5582 9.10301 13.208 -6.0251 -0.167312 -17.6616 -262 1 16.6404 12.9744 5.44078 -0.477448 -16.7093 5.71929 -263 2 16.2955 13.8866 5.54247 6.71099 -18.3284 -17.4666 -264 2 16.51 12.593 4.54035 -5.5475 22.5864 15.6708 -265 1 6.17495 10.0683 0.210584 -22.0037 -7.52033 -29.8636 -266 2 5.35839 10.4511 0.557392 5.20282 -1.85407 -1.83494 -267 2 6.76092 10.0813 0.943985 23.8798 0.550264 15.5383 -268 1 12.3644 6.05734 4.04236 -20.6788 -35.4367 28.6454 -269 2 12.4738 6.70802 3.38308 -3.94744 31.282 -24.9442 -270 2 11.4212 5.77124 4.03221 20.7152 8.11174 -1.23853 -271 1 0.124733 12.8266 0.203961 1.72956 2.54106 -4.3392 -272 2 0.029974 13.5935 0.786871 -3.06107 -4.47794 0.0529132 -273 2 18.185 12.9963 18.0877 7.84157 1.57112 5.96497 -274 1 3.83931 18.5785 8.61972 17.9182 -8.56599 -14.1766 -275 2 3.58625 18.36 7.70531 -6.70328 -0.941099 8.10721 -276 2 3.07994 0.282626 9.06556 -18.5101 7.20519 -0.527908 -277 1 7.37599 17.2741 4.45241 45.8101 34.7343 -2.7797 -278 2 8.02493 17.9603 4.76808 -26.0663 -25.3607 -1.65849 -279 2 7.47725 17.3636 3.49301 -12.8678 -9.31687 6.18264 -280 1 9.20909 17.0315 12.2197 44.1268 -5.71549 17.0535 -281 2 9.48765 16.172 11.8421 -16.3435 15.6721 -2.29993 -282 2 9.99892 17.2887 12.7762 -25.7988 -5.61825 -13.0657 -283 1 13.3284 13.0292 7.94175 -52.6762 -33.6944 -6.73328 -284 2 13.0533 12.253 8.47808 14.3801 9.17086 -2.06391 -285 2 14.1985 13.2855 8.14946 32.3912 12.3835 13.183 -286 1 14.9871 2.94126 15.3478 14.7752 10.8142 -9.8874 -287 2 14.2243 2.52816 14.9303 6.27209 -7.10728 -1.53608 -288 2 15.7054 3.02501 14.6718 -21.9622 -5.02255 13.6584 -289 1 9.85637 15.4939 17.0026 6.25802 5.34328 -5.30261 -290 2 10.2013 14.6312 16.7411 3.93948 4.67059 -1.18803 -291 2 9.35728 15.3668 17.8085 -8.94372 -2.90673 5.88613 -292 1 11.2848 8.23994 16.5492 3.15289 33.2939 2.2253 -293 2 10.8315 7.75123 15.8747 -9.91387 -14.5897 -7.3255 -294 2 11.7506 7.62533 17.1016 4.32393 -13.5731 6.91104 -295 1 3.77097 18.1898 16.7118 5.96936 32.6304 11.943 -296 2 4.24576 17.6768 17.3569 8.77088 -19.0197 5.38959 -297 2 3.7978 0.441972 17.1008 -3.8528 -14.6362 -12.0582 -298 1 2.20581 4.09889 8.95874 4.57905 1.19328 9.26631 -299 2 3.00197 3.55544 8.74643 -17.2537 17.4622 14.7611 -300 2 2.10364 4.24367 9.94001 11.4926 -15.28 -28.3391 -301 1 9.9196 10.3581 9.75231 -27.966 16.15 -17.0738 -302 2 9.34403 11.1055 9.40387 24.0849 -21.7639 18.0289 -303 2 9.87032 10.282 10.7171 1.16507 9.52838 -7.01624 -304 1 9.73405 0.807167 10.8572 18.2139 21.6835 4.91261 -305 2 9.58177 18.5811 11.2204 -14.9491 -12.8069 -2.84973 -306 2 9.10878 1.03014 10.1675 -9.37034 -6.01821 -3.77915 -307 1 9.18221 15.2247 10.2123 -19.1642 -10.2407 -19.6365 -308 2 9.04674 16.0847 9.7631 0.663926 -17.4388 12.4081 -309 2 8.3908 14.6843 9.94105 22.9839 14.6501 17.4764 -310 1 1.00316 9.27987 10.329 14.3691 -27.2472 -11.0896 -311 2 1.16727 10.1904 10.5724 12.779 8.1681 -2.56256 -312 2 1.84996 8.76119 10.1498 -30.7163 35.51 10.5854 -313 1 16.8004 4.89338 8.19813 23.5039 -12.6505 29.7165 -314 2 16.1748 5.31624 8.83318 15.8467 -9.35353 -17.5774 -315 2 17.4877 4.38941 8.71628 -29.2517 16.802 -13.3541 -316 1 14.6379 14.6893 0.402347 -11.159 -0.978579 14.7724 -317 2 14.9609 15.3376 1.05877 0.0769081 -12.0935 -6.53519 -318 2 13.9048 14.1906 0.841144 15.9383 15.9909 -14.4014 -319 1 3.51181 11.0525 9.63829 2.1739 12.5105 -11.7746 -320 2 3.41507 11.3617 10.5484 4.86707 2.92948 -3.5212 -321 2 3.25155 11.8076 9.06383 -0.0479228 -15.275 7.06779 -322 1 11.0289 10.8695 1.26208 17.169 21.0662 -6.34954 -323 2 11.1535 11.716 0.753779 -4.03889 -27.9068 14.1765 -324 2 10.1142 10.5923 1.16471 -3.02205 2.54599 -1.38039 -325 1 13.2239 7.06188 12.8977 -30.3793 3.52384 -4.06516 -326 2 14.1381 6.84046 12.8922 25.6531 -5.59605 1.27225 -327 2 12.7471 6.22139 12.9668 3.13335 6.34025 -4.15647 -328 1 9.62584 1.88878 0.937813 20.0839 -1.09549 37.2578 -329 2 8.77484 2.11506 0.623903 -26.2152 1.3675 -15.013 -330 2 10.1764 1.70882 0.191067 9.10224 -0.512606 -16.4895 -331 1 10.6054 13.537 4.7508 -3.45661 -5.20977 -1.23778 -332 2 11.3208 12.9359 5.04367 -5.78837 16.6981 -6.98771 -333 2 10.4128 14.1619 5.47507 11.2154 -13.4565 -5.70688 -334 1 14.2525 1.6915 10.8868 25.1006 21.2848 4.13062 -335 2 15.0842 1.26497 10.6465 -4.75627 -8.22365 -3.1417 -336 2 14.5069 2.62992 10.8824 -13.5101 -4.08816 2.36647 -337 1 14.6678 12.4248 11.7157 -12.7858 -12.3306 -9.5252 -338 2 15.5574 12.5766 11.3177 -24.032 -11.5318 -4.29299 -339 2 14.0022 11.9667 11.1187 32.4402 16.632 10.9337 -340 1 8.24065 5.08218 9.78509 -7.81525 41.6802 29.5679 -341 2 7.45364 5.10173 10.3836 16.236 -11.1581 -20.3292 -342 2 8.36822 4.22882 9.41503 -10.4798 -31.0118 -7.50393 -343 1 1.59893 16.8132 18.3262 1.78713 43.6046 -19.4726 -344 2 1.99225 17.1675 17.4932 -13.4068 -2.95443 18.1753 -345 2 1.72693 15.8931 18.2458 9.12037 -33.6792 3.80865 -346 1 1.43382 17.2563 15.3383 70.3372 -10.1908 -13.5082 -347 2 1.32309 18.1562 15.5759 -5.39176 26.6374 11.2222 -348 2 0.623143 16.841 15.3782 -64.6751 -20.2725 0.847241 -349 1 3.73599 5.55499 6.2196 -13.8181 39.8005 -2.84681 -350 2 3.32092 6.26594 6.76194 2.21889 -20.7758 -8.723 -351 2 4.19567 6.05321 5.52665 5.67395 -4.434 2.61268 -352 1 12.357 9.41487 14.1826 15.3987 -29.3966 1.09302 -353 2 12.9591 8.63784 13.9021 -33.8501 34.209 16.2235 -354 2 11.936 9.15457 15.0346 16.6427 1.77305 -15.4117 -355 1 4.0362 15.2647 6.90572 33.8672 24.728 -7.08093 -356 2 3.45744 16.0249 6.7945 -6.17655 -1.99751 -5.28974 -357 2 4.92941 15.6518 6.66696 -29.006 -22.9584 9.78444 -358 1 0.606517 8.56128 14.8606 9.39684 15.8059 -8.30397 -359 2 0.498099 9.52604 14.9437 -1.87135 -9.61679 5.58044 -360 2 1.28855 8.50016 14.167 -9.83185 -6.21013 7.33103 -361 1 12.9763 8.3683 10.3434 1.19405 4.03237 -29.9304 -362 2 13.7163 7.90436 9.89822 -7.22584 1.47622 17.5396 -363 2 12.9003 8.0957 11.2534 8.23718 -11.529 10.7869 -364 1 15.2983 7.63672 3.47583 -36.323 -26.5913 31.5529 -365 2 14.5024 7.10501 3.29647 15.7237 15.5958 -25.1442 -366 2 15.2922 7.47095 4.43335 26.8259 14.207 -3.84044 -367 1 17.3208 6.63818 0.028906 -16.9884 17.5938 -6.80353 -368 2 16.7479 6.05403 0.554933 4.15554 3.30118 -7.73843 -369 2 16.7141 7.27151 18.2009 11.1968 -20.2911 18.275 -370 1 8.79355 6.92545 7.84172 -17.9944 -26.8715 17.7017 -371 2 9.63968 7.32585 7.85068 34.0918 14.4557 -5.0304 -372 2 8.77688 6.39871 8.67404 -5.99252 8.25367 -18.4431 -373 1 12.3209 0.607808 1.1741 -9.70621 -1.67076 -6.18378 -374 2 12.995 1.15082 1.58835 11.8921 -6.95349 3.94176 -375 2 12.79 18.5825 0.66073 -1.23695 5.23567 5.50046 -376 1 5.68514 15.097 14.5145 3.67475 30.0662 -16.0184 -377 2 4.72797 15.1695 14.4772 -3.92865 -1.97247 7.85561 -378 2 6.02476 15.8935 14.032 -4.97132 -21.5573 17.6103 -379 1 3.822 6.53853 1.67803 9.4136 -3.73603 -11.0507 -380 2 3.54968 7.33117 1.17576 -2.2757 -10.4776 17.1213 -381 2 3.81642 6.7886 2.60252 -0.785086 8.11893 4.5328 -382 1 3.89262 11.6088 12.227 13.3033 3.31132 5.82178 -383 2 4.72051 12.1032 12.348 -1.72331 -9.21471 -1.78635 -384 2 3.26281 12.0921 12.7526 -14.3078 7.33513 5.3451 -385 1 5.45444 3.88172 15.8755 10.9934 63.7886 22.8921 -386 2 5.90627 3.24049 15.3708 25.1493 -29.4334 -15.1609 -387 2 6.11665 4.65725 15.9739 -37.1513 -37.4972 -5.17498 -388 1 14.4636 10.317 4.39501 8.04256 -17.7362 -43.5508 -389 2 14.9051 9.88853 5.13417 -2.05112 -4.59794 0.583625 -390 2 14.7084 9.81768 3.53446 -13.0506 20.827 46.8358 -391 1 7.94949 17.2895 9.24469 -12.4073 10.6503 -4.49958 -392 2 7.23447 17.5423 9.86969 11.4984 0.663317 -18.2334 -393 2 8.01085 17.8889 8.47627 -8.74254 0.310971 13.2931 -394 1 4.4986 14.4237 3.96317 22.7921 6.59984 27.2073 -395 2 4.89523 15.3318 4.14709 -15.7294 -33.8816 -1.82578 -396 2 4.80237 13.7713 4.67129 -10.4496 32.1184 -24.135 -397 1 14.3358 7.38467 15.7635 24.4704 6.70756 7.84838 -398 2 15.2401 7.23754 15.391 -26.2451 3.74497 13.7384 -399 2 14.4998 7.83446 16.6232 -7.00308 -11.7114 -18.5693 -400 1 2.86875 18.2246 1.90934 8.22952 29.9251 46.5059 -401 2 2.54447 17.7626 1.17928 -17.7355 -34.6574 -39.0362 -402 2 2.08284 18.4154 2.45796 15.223 4.61378 -9.70941 -403 1 7.96139 1.61197 4.52525 29.4796 -3.5692 28.5612 -404 2 7.4985 1.83317 3.72811 -4.47294 12.8461 -13.1797 -405 2 8.84188 2.051 4.57628 -23.8244 -8.06079 -10.6756 -406 1 2.69247 14.1251 17.7583 -39.7925 -12.5472 14.0506 -407 2 1.78944 13.8074 18.0556 30.3506 3.26472 -13.0537 -408 2 3.33089 13.517 18.1683 -2.67461 8.7222 -7.81087 -409 1 0.711797 1.68055 13.8626 44.8563 0.102291 -15.8697 -410 2 0.854596 1.56791 14.7929 -2.34617 -4.64243 17.7358 -411 2 18.4557 1.86826 13.7064 -36.5874 5.33291 1.35002 -412 1 4.5582 18.5986 13.9691 17.69 -10.1212 -17.3986 -413 2 5.37614 18.0918 13.7297 -17.5363 18.7277 11.6893 -414 2 4.4096 18.4453 14.9034 -4.80692 -4.44744 5.40837 -415 1 7.10973 0.453475 18.3742 -17.6731 43.6393 33.9394 -416 2 6.99644 0.098599 17.5235 3.55611 -15.5456 -38.0778 -417 2 6.34312 1.05085 18.5323 11.5496 -19.3687 -0.295067 -418 1 16.0934 18.4421 14.1505 -13.5696 -24.3411 -34.6818 -419 2 15.444 17.7866 13.7542 20.5302 26.3107 23.9987 -420 2 16.0379 18.4915 15.109 -11.2087 -0.403296 -0.42938 -421 1 10.1156 4.52417 16.2956 -63.5341 -10.6596 -28.1335 -422 2 10.9808 4.34247 16.5381 54.6034 1.03427 17.4186 -423 2 9.84863 3.69679 15.8473 1.5569 12.8802 9.55133 -424 1 15.8226 17.9425 4.41327 -12.7412 7.89699 33.5898 -425 2 16.5547 18.5732 4.53052 -9.15632 -3.64108 -2.38506 -426 2 15.1071 18.2295 5.06915 28.1993 -15.1976 -35.9746 -427 1 6.9246 17.3574 13.7412 41.9162 15.5861 -1.52717 -428 2 7.49648 17.8115 14.4369 -23.1807 -22.4309 -23.3681 -429 2 7.52703 17.1963 12.9658 -13.588 5.84324 25.6525 -430 1 13.2892 6.57209 6.73437 -45.0771 -7.84691 9.23056 -431 2 14.2146 6.66317 6.83486 35.9508 1.69852 -11.4068 -432 2 13.0394 6.38579 5.82242 8.43649 1.47489 -3.25235 -433 1 7.6616 2.3861 9.17526 8.07841 -8.24756 -37.8228 -434 2 7.32169 2.39592 10.0555 -17.554 -3.79201 20.6206 -435 2 6.95914 2.1022 8.53308 18.9972 7.96045 22.8376 -436 1 15.1464 14.8771 13.6482 -9.08859 5.19149 1.30171 -437 2 15.0308 15.0223 14.6069 -2.64384 -0.244686 -12.5428 -438 2 14.3194 15.1152 13.1798 15.9342 -4.32482 12.4068 -439 1 9.29105 8.34315 3.70472 25.3147 -22.6228 7.1656 -440 2 10.1776 8.75859 3.73678 -14.6049 0.788849 -0.227964 -441 2 9.48378 7.39942 3.88081 -7.38963 16.6026 -2.51653 -442 1 17.6854 13.4687 16.4528 1.20699 34.422 -16.619 -443 2 16.7357 13.4337 16.3398 -3.15338 -8.61752 5.60033 -444 2 17.8844 14.3284 16.0065 4.30498 -21.0483 11.9174 -445 1 5.04883 10.6547 2.58751 21.171 -14.0773 3.70172 -446 2 5.87017 10.3468 3.04382 -23.0848 5.17759 -4.78185 -447 2 4.55197 11.1441 3.22928 -5.68041 9.33128 13.9497 -448 1 3.70566 8.3683 10.3381 2.8322 -31.099 -4.13864 -449 2 3.86061 9.29726 10.2176 3.71195 18.7597 0.626964 -450 2 3.86652 8.14601 11.2715 -4.70232 11.1023 -9.34814 -451 1 16.1079 7.11641 6.33859 19.1617 -15.4194 -14.8444 -452 2 16.7241 7.70559 6.80408 -7.69122 -6.37409 -7.38138 -453 2 16.6678 6.33083 6.12136 -24.1396 12.8226 8.63966 -454 1 15.2027 7.00502 9.1117 -12.4455 33.5656 -30.1004 -455 2 16.009 7.42176 9.46585 -11.7729 -5.93044 -7.51071 -456 2 14.9881 7.51375 8.25647 14.3105 -22.443 40.0586 -457 1 6.4525 13.1649 12.9201 -14.4212 4.62434 6.2224 -458 2 7.2977 12.7289 13.0561 -0.519457 -3.7562 7.19322 -459 2 6.25327 13.7237 13.7059 9.03992 -10.4089 -22.4145 -460 1 12.1145 4.49786 13.0694 60.1541 40.3897 -0.599702 -461 2 12.3852 4.68406 13.9868 -12.8154 -8.572 -1.53547 -462 2 11.3952 3.9317 13.0199 -51.9002 -33.7145 4.15206 -463 1 11.3323 8.18365 7.8522 33.2694 0.481688 12.7059 -464 2 12.0901 7.73501 7.43634 -16.2057 -1.97452 -6.97761 -465 2 11.7651 8.45102 8.68662 -20.5523 -0.0583287 -5.01537 -466 1 17.1666 10.776 7.42179 36.6255 -17.1838 -28.5238 -467 2 17.7906 10.0723 7.08441 -19.5131 16.2155 23.227 -468 2 17.2793 11.4524 6.73733 -13.1225 1.2547 8.82205 -469 1 5.22802 18.1471 11.05 -26.218 -15.3265 2.15414 -470 2 4.73762 18.1049 11.901 9.27461 0.443739 -18.2338 -471 2 4.62535 17.7417 10.374 18.9971 14.5949 15.121 -472 1 7.56653 17.6363 1.80821 2.05543 -3.48119 51.3305 -473 2 7.65741 16.7768 1.42856 8.63412 -18.3953 -16.9352 -474 2 7.35855 18.2549 1.13994 -1.30452 14.3677 -27.7338 -475 1 1.85092 12.9256 13.6076 17.4877 19.0754 23.2488 -476 2 1.72104 12.4156 14.4258 -6.17153 0.259213 -13.4945 -477 2 2.19932 13.7866 13.9501 -9.51965 -23.6336 -9.57422 -478 1 9.73868 6.79159 14.8001 -20.4051 42.5069 -0.796717 -479 2 9.95236 5.95211 15.1529 11.7083 -38.3225 9.01974 -480 2 9.967 6.84408 13.8723 6.06139 -4.97285 -7.43337 -481 1 15.2087 4.3972 10.7794 -26.9028 -24.0998 -25.0358 -482 2 16.0082 3.89203 10.8637 24.0661 5.32644 6.50358 -483 2 15.2102 5.16148 11.3322 8.70888 13.5856 17.3899 -484 1 11.1963 6.12482 0.150068 -24.122 -22.6006 13.7234 -485 2 11.2381 5.20796 0.481504 11.6671 13.7026 -10.2768 -486 2 10.2374 6.21547 18.6186 16.3103 12.5014 -3.12394 -487 1 0.19533 11.3359 15.1413 -21.6592 10.769 -30.7731 -488 2 18.4021 11.874 14.3993 14.4722 -20.1415 31.2795 -489 2 18.4481 11.661 15.9631 4.68348 9.49999 -5.94609 -490 1 7.06882 9.13032 7.26059 -22.6631 -3.09615 15.424 -491 2 6.55985 8.40099 7.69941 15.0645 18.9564 -17.5163 -492 2 7.9725 8.82922 7.21375 6.85038 -6.33336 0.902711 -493 1 18.4578 15.4507 12.3537 6.97015 0.808933 -7.22971 -494 2 0.776651 15.5698 12.2511 -16.5258 -3.56518 7.28193 -495 2 18.1456 15.6789 11.4721 -4.11121 -1.28038 2.68538 -496 1 16.5694 4.36967 5.25107 2.45626 -29.8761 41.2812 -497 2 16.7744 3.81151 6.06026 -19.4928 29.4804 -23.4548 -498 2 17.3898 4.32671 4.78168 14.6436 6.44337 -19.6343 -499 1 17.788 3.06911 10.7078 8.19486 16.3181 17.0759 -500 2 0.075758 3.1322 11.0257 -18.3141 -4.46618 -10.1687 -501 2 17.6332 2.20749 10.3226 7.04824 -10.7221 -5.22745 -502 1 12.3142 0.064083 10.1758 -16.6046 52.5698 5.40656 -503 2 11.3746 0.384648 10.259 27.2889 -19.3162 -0.832384 -504 2 12.8178 0.919304 10.3228 -10.5773 -40.3011 -9.47381 -505 1 10.3666 9.83315 12.2981 15.5663 4.35939 24.9446 -506 2 11.1015 9.85063 12.955 -12.9587 3.49885 -14.3711 -507 2 10.1328 8.91188 12.2898 -2.48305 -14.5784 -4.85859 -508 1 0.463654 2.82678 7.01839 21.5285 29.229 11.0876 -509 2 0.875324 3.58845 7.48211 -15.1018 -9.47019 -10.8481 -510 2 0.770257 2.12665 7.58365 -2.10845 -18.3887 2.87796 -511 1 0.478371 15.2358 6.91004 -5.05906 -57.415 8.40739 -512 2 0.585298 15.6463 7.75647 1.85019 10.3725 13.8373 -513 2 0.556531 14.2524 7.18353 -2.63305 52.383 -27.2731 -514 1 16.9534 7.00251 15.3394 -15.9191 6.08615 -6.45156 -515 2 17.6338 7.63543 15.0899 14.1822 -6.8729 3.83609 -516 2 17.3093 6.19568 15.7235 10.8839 2.85836 -7.52482 -517 1 9.0001 12.4151 8.13768 -31.1102 30.9609 25.8163 -518 2 9.37386 11.8218 7.49742 -5.17233 -14.4246 -22.3971 -519 2 8.02402 12.632 8.03373 38.2843 -19.0142 -6.47162 -520 1 1.27238 1.95406 3.05803 -13.5483 -7.94682 -18.4152 -521 2 1.26084 2.61511 2.34121 0.274888 -9.5029 12.9388 -522 2 1.89031 2.22344 3.73293 6.76618 11.1556 -0.474465 -523 1 4.13907 15.1156 9.62039 -21.6353 8.89781 12.928 -524 2 4.07003 15.1439 8.65747 6.73796 -2.17255 1.87071 -525 2 4.96029 14.7006 9.86457 13.8731 -5.89958 -3.36363 -526 1 7.17628 2.17866 14.5671 10.1969 15.6665 0.500505 -527 2 6.99528 1.68402 13.7698 -5.58163 -4.27811 -6.1139 -528 2 7.62131 2.98432 14.249 -3.31044 -9.5634 8.35677 -529 1 18.6082 14.7131 2.1481 32.6395 -16.0207 -3.46113 -530 2 0.838003 15.1297 2.25966 -5.15041 -8.02703 -3.38947 -531 2 17.988 15.3544 2.42675 -27.9684 22.1971 4.74449 -532 1 9.94138 2.79524 12.9422 16.7157 -19.9527 -5.96647 -533 2 9.79404 2.1456 12.2228 -2.63367 12.9584 8.66897 -534 2 9.17835 3.36299 13.0326 -7.96092 5.51528 -6.54514 -535 1 2.80444 8.90955 13.0076 -17.7822 -13.1167 0.317539 -536 2 3.06361 9.80599 12.872 10.5962 22.9278 -4.25378 -537 2 3.5122 8.48618 13.4775 15.1932 -9.60442 7.00981 -538 1 3.236 8.3574 3.63664 -2.86765 -22.2709 68.2353 -539 2 3.45085 9.0718 3.07326 14.564 28.9211 -13.7717 -540 2 3.47645 8.58669 4.60794 -11.4307 -4.68562 -51.1711 -541 1 5.62853 7.18594 8.51094 8.63755 21.4894 2.16978 -542 2 5.46784 6.31815 8.13889 -3.95344 -9.53044 10.3317 -543 2 4.96415 7.47792 9.15047 -3.24726 -12.0183 -2.29801 -544 1 14.8757 1.26039 2.01768 8.95967 6.82752 -28.1452 -545 2 14.9353 2.01952 2.56559 -6.40438 15.8227 28.9683 -546 2 15.2784 1.60993 1.21235 -4.35761 -14.1118 -5.79377 -547 1 8.22892 15.2012 0.850139 10.8537 -12.6178 7.38979 -548 2 9.02213 14.9338 1.33488 2.38301 14.3333 -0.830013 -549 2 7.55366 14.6663 1.27665 -9.08858 2.03607 -6.2405 -550 1 15.6387 1.34587 7.23673 -38.2068 -12.1482 -8.38322 -551 2 14.9277 0.724731 6.91269 26.6184 17.4884 8.18161 -552 2 15.1173 2.1119 7.53894 10.4663 -3.86302 -4.52487 -553 1 4.90142 13.0959 18.5232 17.6249 -4.01801 23.9701 -554 2 5.32755 13.082 0.76977 -10.7656 0.632793 -19.6876 -555 2 5.44764 13.7122 18.0259 0.499955 -3.74815 -4.96885 -556 1 15.3368 8.46948 18.1479 21.2409 26.352 -19.7425 -557 2 15.8061 9.12264 17.5623 -15.5364 -21.5252 11.6976 -558 2 15.3318 8.91689 0.353875 -5.84476 0.442576 5.05054 -559 1 12.0708 3.01842 18.3809 -8.91332 38.2285 -17.9492 -560 2 11.9316 2.65996 0.60646 7.08072 -18.979 4.32412 -561 2 12.6022 2.47389 17.7995 4.78982 -18.1658 8.07002 -562 1 13.2139 12.6752 5.17768 -9.57044 10.0795 -9.57129 -563 2 13.7464 12.0348 4.69253 1.60656 -5.44915 8.62561 -564 2 13.2564 12.5123 6.11793 10.4898 -3.48459 7.66387 -565 1 6.05443 7.0356 0.031519 0.0605761 -19.9038 6.17744 -566 2 5.93935 7.95118 18.5019 3.71712 34.2187 -1.98634 -567 2 5.39095 6.86665 0.702638 -7.83388 -10.1683 0.476271 -568 1 17.7528 16.0276 15.0213 -25.9758 6.2762 6.79882 -569 2 16.9476 16.5457 15.105 3.54626 -1.67183 20.5845 -570 2 17.7479 16.0055 14.0813 22.8568 -13.146 -30.1028 -571 1 13.196 0.994907 16.5363 6.37162 1.07879 13.9702 -572 2 14.1481 0.997912 16.7614 -14.4757 -4.73392 -6.84542 -573 2 12.8833 0.094199 16.7238 3.07394 5.84273 -8.05351 -574 1 11.1253 14.5647 7.20271 13.6513 20.7581 -19.5035 -575 2 10.4007 14.3183 7.72981 -32.979 -9.13798 24.3252 -576 2 11.7186 13.8255 7.26943 15.8912 -3.80541 2.99114 -577 1 17.5081 8.62849 2.08107 17.5857 37.593 18.6886 -578 2 16.6801 8.63471 2.55495 -11.5266 -11.0229 1.73392 -579 2 17.5233 7.88242 1.516 -4.85302 -28.502 -20.2632 -580 1 12.3547 8.01168 2.02213 2.8693 7.47745 -2.1033 -581 2 12.2384 8.8582 1.54611 -1.5199 -14.1485 9.25757 -582 2 11.9739 7.3152 1.48261 -4.60849 0.564674 -12.802 -583 1 11.8761 14.6165 10.3364 -1.28632 -27.1744 -11.0444 -584 2 12.1004 13.7873 9.81464 -15.5434 34.4502 21.6186 -585 2 10.8993 14.6888 10.473 22.8986 -6.0814 -12.7032 -586 1 6.89524 7.05211 15.6117 2.70483 5.93472 10.8866 -587 2 7.81004 7.26536 15.3122 -19.1207 -0.823892 9.8847 -588 2 6.66676 7.54167 16.4408 15.3743 -10.0989 -25.4065 -589 1 8.00326 4.73593 13.4743 46.2088 18.1039 21.0673 -590 2 7.23337 4.7302 12.9572 -37.1051 2.19442 -26.1447 -591 2 8.40671 5.62958 13.343 -9.63909 -26.9075 5.20654 -592 1 13.4128 12.1818 14.2522 -5.46405 -2.8504 7.05596 -593 2 12.9414 11.3292 14.2657 10.1901 3.29349 -5.65079 -594 2 13.7875 12.315 13.3696 -1.58979 -2.51674 3.72795 -595 1 14.8395 9.42189 7.30548 -10.1492 -33.0314 -14.9507 -596 2 15.7087 9.765 7.42505 18.3001 17.1245 4.25051 -597 2 14.2269 10.0768 7.57319 -16.3703 19.68 11.0075 -598 1 12.6526 17.0686 3.07252 -25.5483 38.6692 13.4046 -599 2 12.8376 17.5237 3.93373 3.7914 -19.7635 -24.6942 -600 2 11.9913 17.6958 2.63477 29.3498 -30.5169 14.5322 -601 1 1.15545 7.13838 17.4647 -1.30818 10.8795 -24.4228 -602 2 0.330359 7.36323 17.9184 3.51096 -10.352 -1.0007 -603 2 1.05514 7.47868 16.5422 2.6229 -4.15873 21.1004 -604 1 12.7562 5.15096 15.6457 46.9745 -3.15458 16.4241 -605 2 13.4512 4.55662 16.0315 -23.8856 11.8204 -16.5269 -606 2 13.2414 6.00335 15.5788 -13.869 -10.6853 0.37407 -607 1 2.53993 3.38757 4.97618 -24.4059 44.0626 48.9955 -608 2 1.7609 3.18232 5.58922 29.5313 1.39757 -24.0522 -609 2 2.84154 4.31546 5.27885 -6.94106 -48.8689 -12.2378 -610 1 8.33186 11.2983 13.4548 -25.447 4.99647 44.923 -611 2 8.4244 11.0562 14.4444 7.04045 1.38295 -54.395 -612 2 8.91168 10.8786 12.8197 20.7237 -12.5345 14.2107 -613 1 12.8689 1.31514 13.3384 4.70567 59.9078 -15.5432 -614 2 13.42 1.58034 12.5659 -9.46235 -19.1343 13.2352 -615 2 12.4231 2.17844 13.5496 8.70338 -32.6779 -3.58081 -616 1 6.34008 13.7169 2.14963 -19.3306 -6.11379 22.757 -617 2 5.63978 13.877 2.82959 17.9638 4.85668 -21.8758 -618 2 6.88351 13.0442 2.56282 8.57629 -2.48731 -1.94932 -619 1 15.9206 6.61444 12.7992 -23.3103 -26.3741 2.68057 -620 2 16.3106 7.25195 12.2393 16.9755 20.6681 -18.7226 -621 2 16.4213 6.59661 13.608 7.79648 1.05266 12.4236 -622 1 16.8298 0.712824 9.59482 4.79811 -22.8344 -3.47194 -623 2 16.8791 18.3713 9.72616 -6.98639 26.8255 -1.99774 -624 2 16.5452 0.8605 8.67269 -2.39382 -2.67689 10.2173 -625 1 6.14624 11.7631 8.37671 0.189841 -56.9827 6.97012 -626 2 5.32447 11.4591 8.84151 16.7156 13.8425 -13.046 -627 2 6.64226 10.8931 8.20176 -19.0535 39.3101 2.14415 -628 1 2.88754 8.61261 0.453821 12.2401 -11.553 -23.675 -629 2 2.45212 8.04764 18.3917 -4.84247 31.247 26.7064 -630 2 2.34875 9.28564 0.895642 -13.4946 -8.81401 -13.4914 -631 1 10.1674 10.4623 6.50123 4.87464 -2.88608 -13.8248 -632 2 10.6087 9.69731 6.89122 -0.620763 2.00125 4.93232 -633 2 10.4694 10.4636 5.56932 -5.34739 2.02001 15.3519 -634 1 6.7142 15.6951 6.55167 22.995 7.84961 12.6004 -635 2 7.14328 16.1838 7.27089 -9.73558 -8.55589 0.364412 -636 2 7.21237 16.006 5.79102 -10.9792 5.43097 -10.3878 -637 1 6.445 13.1807 5.57797 -3.32019 -20.8794 2.06608 -638 2 6.7301 13.9465 6.07331 -1.80129 7.88671 5.96843 -639 2 6.09943 12.5433 6.22286 1.13913 6.90777 -2.85329 -640 1 16.8242 12.5629 9.83758 3.36613 -21.9924 0.476486 -641 2 16.9985 11.8651 9.16533 -5.29916 18.5903 6.02329 -642 2 16.5644 13.3844 9.42716 1.61266 3.35571 -10.8679 -643 1 6.03738 2.95058 2.86354 -7.51536 -24.4327 -2.00067 -644 2 6.40977 3.757 2.57075 14.9417 32.1903 -3.64532 -645 2 5.57703 2.61747 2.09059 -4.23441 -8.07329 -3.19257 -646 1 10.9114 3.33767 3.30112 3.4906 -2.16377 5.30702 -647 2 10.297 4.02722 3.58926 -1.61521 -6.66566 -5.52383 -648 2 10.5127 2.84524 2.57795 -5.77666 1.81375 -3.43243 -ITEM: TIMESTEP -10 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.68194 7.08301 17.95 -9.31723 -4.61569 5.17534 -2 2 7.78696 6.81626 18.2438 14.604 4.05464 -8.83536 -3 2 8.80373 6.759 17.0506 -2.23465 -3.10488 4.80291 -4 1 18.5422 8.2512 6.84005 -1.85374 20.2636 49.1182 -5 2 0.133718 7.9438 5.98823 13.4692 -17.0673 -32.1853 -6 2 0.402402 7.78616 7.5434 -4.29735 0.835788 -17.7519 -7 1 8.38516 18.5522 6.81414 18.1861 9.65042 -3.37417 -8 2 9.3349 0.126592 6.72298 -16.1755 -3.42506 1.43069 -9 2 7.92248 0.594936 6.31239 0.819355 -0.881225 3.09059 -10 1 6.59178 1.84314 11.71 32.0023 -4.98621 -11.2566 -11 2 5.89352 2.36713 12.0513 -24.1224 14.8358 13.0259 -12 2 6.19214 1.0378 11.3953 -8.69892 -12.638 -2.90229 -13 1 7.13386 5.75674 2.33026 -14.5408 0.616599 17.9391 -14 2 6.48306 6.1089 3.01881 22.5383 -2.3727 -34.6055 -15 2 7.09544 6.2305 1.47237 -10.8297 -1.47351 21.389 -16 1 16.2171 10.1491 16.1328 -28.1801 3.24526 14.6911 -17 2 17.0032 10.2274 15.6211 19.8027 8.68317 -10.1896 -18 2 15.8342 11.0337 16.2804 9.6716 -6.93987 -4.62354 -19 1 10.6069 15.0266 2.30703 -4.98248 -17.7421 -7.27467 -20 2 10.5595 14.4209 3.0573 0.524935 2.03122 3.93242 -21 2 11.0455 15.8043 2.63229 7.74565 12.2645 5.86516 -22 1 17.1614 8.24714 10.3877 8.07926 1.42828 6.48104 -23 2 16.5623 8.78009 10.9215 0.0316367 4.64377 2.31684 -24 2 17.9785 8.76022 10.2824 -6.97801 -4.40732 0.702868 -25 1 14.8935 15.8724 16.3278 20.2214 -7.01151 6.5945 -26 2 14.0152 16.2142 16.2283 -22.9266 5.478 3.03945 -27 2 14.9126 15.3591 17.1528 -4.85523 2.97165 -4.07838 -28 1 12.1655 13.3835 0.413391 7.36911 -14.3954 12.824 -29 2 12.1103 13.7323 18.1651 -6.85057 6.78658 -3.29346 -30 2 11.6807 13.9152 1.05851 -4.03153 8.23708 -7.75902 -31 1 9.27599 5.36662 4.05276 -29.4571 7.127 11.0843 -32 2 8.67176 5.26931 4.85064 22.4619 1.60875 -30.6294 -33 2 8.67539 5.53054 3.28716 9.26602 -4.36827 15.8404 -34 1 1.82909 4.27439 11.6483 -10.3032 26.7578 -2.81239 -35 2 1.73625 5.21877 11.9337 1.99226 -22.9368 -8.90994 -36 2 2.3645 3.83767 12.2983 6.89168 -8.93952 11.7704 -37 1 1.96701 6.83625 8.36791 0.700563 -10.6105 -3.76521 -38 2 2.46094 7.16371 9.10974 5.61647 13.7513 9.96296 -39 2 1.91553 5.8986 8.57777 -2.9792 -4.95164 -6.48224 -40 1 5.40472 4.39468 7.93775 -13.5219 -10.4794 -16.6571 -41 2 5.47247 3.43369 7.82443 4.19114 6.69916 9.09153 -42 2 4.75726 4.62849 7.24994 8.09624 5.59982 9.8174 -43 1 3.2394 2.92305 17.5474 -0.484589 33.1528 15.1222 -44 2 3.93082 3.31406 16.9898 -0.722116 -4.79924 0.441987 -45 2 2.93778 3.68549 18.1255 3.8058 -28.2307 -17.5498 -46 1 7.46921 5.27133 6.11017 -1.04832 -15.5011 48.3459 -47 2 7.90561 5.59719 6.92877 -0.90713 11.0324 -30.0179 -48 2 6.96076 4.54233 6.5205 0.0145083 12.7024 -20.8234 -49 1 9.7753 7.02229 11.9825 10.38 0.905424 28.7819 -50 2 10.3185 6.36588 11.5577 3.53671 -5.58238 -7.94156 -51 2 9.14507 7.32646 11.347 -14.6838 3.32198 -19.6076 -52 1 14.1071 3.54759 8.03608 -23.8038 4.02857 -21.7378 -53 2 13.5341 4.25359 7.68722 9.9361 -9.73972 0.838395 -54 2 14.4214 3.88758 8.85457 11.6 9.53944 21.926 -55 1 4.79933 17.2591 4.02624 -13.379 0.496236 -8.73431 -56 2 5.57386 17.851 4.10922 -16.5825 -9.69995 -7.24814 -57 2 4.20396 17.5018 3.27728 17.9024 3.63898 12.5287 -58 1 16.5033 16.6227 10.0525 8.55043 -2.52252 -17.4646 -59 2 16.0579 16.4137 10.8501 -12.2091 1.77219 28.6058 -60 2 15.9447 16.1927 9.39741 3.82195 1.69594 -5.2917 -61 1 1.95551 4.92482 0.485806 10.2127 4.96395 -0.662752 -62 2 2.54163 5.27617 1.19707 -10.7364 -3.48306 -18.9921 -63 2 1.87778 5.63364 18.4632 -0.0680824 -4.88148 10.5435 -64 1 11.8064 13.3616 16.2803 -11.2011 -32.854 -16.2783 -65 2 11.3068 12.5375 16.4476 0.201944 14.5536 10.5803 -66 2 12.2047 13.1237 15.424 4.38621 16.2025 8.43328 -67 1 10.1065 11.0626 16.9483 14.8798 -23.3813 0.89342 -68 2 10.5718 10.2022 17.1278 -15.1514 23.106 -6.44625 -69 2 9.22125 10.8281 16.6474 0.614925 -0.65596 2.44857 -70 1 11.7253 17.5378 13.4688 -9.94093 -22.0621 2.41868 -71 2 12.2582 16.9669 12.8891 0.443382 11.1567 2.15207 -72 2 12.0419 18.4322 13.3705 7.56806 8.72697 -4.32807 -73 1 6.34321 9.31538 12.2256 -11.115 -24.1278 -16.4431 -74 2 6.95505 8.9709 11.5438 -2.74015 10.4344 10.5225 -75 2 6.7633 9.99127 12.7388 17.4243 13.1424 4.46627 -76 1 16.2194 12.7233 2.70094 -4.61478 -5.953 2.95318 -77 2 17.0002 13.1906 2.44934 22.4693 3.83429 -6.00104 -78 2 15.5655 13.415 2.69545 -17.2672 7.42791 2.42646 -79 1 0.634553 12.563 5.85853 -28.5577 11.9856 -12.6208 -80 2 0.914444 12.5082 4.92832 1.43228 -1.32003 11.8657 -81 2 18.3286 12.8558 5.76638 29.2028 -10.3468 5.65715 -82 1 5.19236 16.3841 18.4962 26.3246 -0.931967 -7.14386 -83 2 5.89246 15.8922 18.0344 -14.3156 -2.38899 -1.49205 -84 2 5.72254 16.912 0.454606 -10.9177 5.22319 5.94171 -85 1 0.515157 7.6307 4.06432 40.0561 19.3507 -22.9165 -86 2 18.554 8.04388 3.41083 11.6748 -7.97607 10.9949 -87 2 1.4672 7.83805 3.73432 -48.6916 -7.92141 18.8197 -88 1 3.14333 8.89821 6.52388 -38.7347 7.47588 -5.16066 -89 2 3.55606 8.61579 7.33755 0.264066 -1.79724 4.80444 -90 2 2.15121 8.92424 6.67318 38.4004 -3.38228 -2.38687 -91 1 7.3156 10.3041 16.1747 -22.5262 4.44621 22.8692 -92 2 6.53394 10.4783 15.6406 9.03524 -0.350523 -4.2891 -93 2 6.93671 10.3234 17.0875 14.5541 -1.9474 -13.7178 -94 1 11.1094 1.06061 5.00017 -8.33223 -1.63593 -20.1003 -95 2 11.1653 1.90766 4.53999 7.02718 4.91961 9.72987 -96 2 10.7116 0.517103 4.29895 3.46448 -7.62041 12.1963 -97 1 4.44086 2.70257 13.2121 -8.76198 -6.25056 -12.8305 -98 2 4.61839 3.20254 14.0253 0.411253 -15.6801 0.294236 -99 2 4.37598 1.71769 13.3483 2.92355 28.3656 12.0639 -100 1 8.41481 10.0299 1.78755 2.58083 -12.9704 20.4417 -101 2 8.40154 10.6596 2.53141 -0.930044 -1.16348 -6.83089 -102 2 8.61337 9.15635 2.20556 -3.35942 21.7495 -11.7521 -103 1 10.5245 1.75336 15.553 -8.62776 -1.95945 -5.61675 -104 2 11.4377 1.70086 15.8172 12.2485 -3.82632 7.39579 -105 2 10.5516 1.84495 14.595 -9.16331 1.82149 -1.12185 -106 1 2.77042 12.9421 7.75317 -7.76237 -6.33315 7.0975 -107 2 3.33238 13.5624 7.27685 -2.67968 -0.352894 -3.41328 -108 2 2.03777 12.7029 7.16368 7.79305 2.46945 -1.53229 -109 1 3.64399 11.6862 5.32015 -16.8384 -12.8234 -6.75612 -110 2 3.34983 11.0669 6.0167 8.99611 10.2661 -11.4747 -111 2 2.85416 11.8487 4.76712 13.6242 -0.0526402 5.20338 -112 1 6.87773 14.4784 16.8504 -8.96924 2.55968 -2.39612 -113 2 7.58262 13.8601 16.6681 3.90388 -1.06505 3.99858 -114 2 6.56163 14.7581 15.9821 -2.66358 -1.99085 3.97159 -115 1 14.1744 14.5416 3.41044 10.3942 -0.651763 -8.74467 -116 2 13.655 15.3132 3.20132 -4.79611 11.1016 -3.67227 -117 2 13.7666 14.1672 4.18264 -6.53868 -10.5118 9.50782 -118 1 8.26761 18.1769 16.0723 60.4333 -9.62543 6.95109 -119 2 8.90915 17.473 16.3173 -32.2452 -3.35667 -3.16806 -120 2 8.92378 0.250762 16.016 -23.6515 10.2222 -7.97846 -121 1 4.73314 1.61844 4.90498 10.4838 29.1168 -20.5116 -122 2 3.92346 2.13642 5.08344 11.5633 -7.75976 -5.77828 -123 2 5.26159 2.15735 4.23518 -22.3286 -21.1319 29.8735 -124 1 15.1246 12.8394 16.4387 17.4381 -4.51065 31.9511 -125 2 14.6778 12.9897 17.2989 -1.10989 -1.43715 -21.8055 -126 2 14.5277 12.6911 15.7205 -25.4533 -1.78625 -11.0751 -127 1 15.7863 18.3852 16.7922 25.908 13.3822 31.678 -128 2 16.4574 18.6243 17.5189 -32.4234 -15.7026 -31.1655 -129 2 15.6278 17.4293 16.8067 2.01305 5.51074 5.25351 -130 1 1.13886 1.13555 16.5514 1.07915 19.6556 20.6288 -131 2 1.93696 1.57732 16.8903 -4.88731 -5.90564 -11.4186 -132 2 0.480719 1.50241 17.171 6.36092 -10.7053 -11.3623 -133 1 18.0845 4.58532 15.87 11.914 -13.2929 -3.66508 -134 2 18.5793 3.94883 15.3177 -8.66069 11.808 8.70591 -135 2 18.5822 4.70936 16.6848 -0.518448 -1.56194 -3.55701 -136 1 12.2302 16.9486 16.128 -37.9176 -11.5423 26.3029 -137 2 11.3914 16.5899 16.5469 36.4287 7.40626 -6.62059 -138 2 11.916 17.193 15.2634 5.93841 3.5336 -18.1806 -139 1 15.8788 2.54988 17.9721 5.087 5.67773 0.124923 -140 2 15.7549 3.4391 18.3687 -1.45045 -15.8437 -11.8457 -141 2 15.6801 2.58174 17.0093 2.38633 7.36977 18.7833 -142 1 6.70786 13.8001 10.254 -2.60372 -2.62943 9.53833 -143 2 6.60649 13.5148 11.1732 2.18143 10.2669 -0.00882184 -144 2 6.57676 12.9909 9.76432 1.5038 -4.69959 -12.8892 -145 1 10.141 18.2121 2.80409 9.87418 27.4677 -18.8777 -146 2 10.2555 0.291999 2.14056 -0.137226 -16.5556 14.9505 -147 2 9.2689 17.8819 2.61553 -12.127 -4.1331 -0.131977 -148 1 2.97228 17.7542 6.06181 -6.28377 0.301135 37.0401 -149 2 2.07671 17.601 5.72694 10.6784 2.25774 -14.0772 -150 2 3.63482 17.801 5.37776 -0.270923 -2.52512 -18.6151 -151 1 12.5659 17.001 7.96656 -23.415 -18.3905 24.197 -152 2 11.9071 16.2804 7.97312 11.7411 4.46809 -11.7089 -153 2 12.3405 17.4671 8.78984 12.2149 7.72109 -10.0441 -154 1 14.887 15.2779 8.2893 -14.8827 1.47652 2.73183 -155 2 14.0296 15.7117 8.25541 -5.1427 0.792443 13.0916 -156 2 15.1979 15.4906 7.42354 24.2513 -3.00083 -20.068 -157 1 17.5454 18.3111 0.374663 -13.7707 -4.14946 -2.00055 -158 2 18.2555 17.754 0.11924 20.0055 -25.3354 -15.9225 -159 2 18.0059 0.295965 0.896687 2.592 26.2966 16.2474 -160 1 0.909555 10.373 1.4127 -25.0541 -38.6286 23.1399 -161 2 0.0989843 9.87796 1.71715 28.402 10.794 -7.01331 -162 2 0.540787 11.0804 0.922273 -7.26144 30.0328 -22.846 -163 1 1.56438 12.1819 3.32547 9.10171 15.3717 9.49092 -164 2 1.376 11.5384 2.66679 -5.32309 -27.3061 -8.25977 -165 2 1.61002 12.9703 2.79202 3.36268 15.5511 3.76031 -166 1 0.549815 17.2556 4.8751 10.3167 15.4421 -19.2536 -167 2 -0.00199658 17.9163 5.26632 -10.5855 22.2192 -2.30371 -168 2 0.434878 16.519 5.43169 0.723696 -37.6018 20.4622 -169 1 1.10394 1.00198 9.3932 22.7427 9.86492 -7.57605 -170 2 1.42144 0.685439 10.2466 -8.09769 -6.36772 6.76546 -171 2 0.213433 0.697197 9.27667 -15.9263 -9.88137 4.21803 -172 1 16.7947 2.33275 13.2864 3.73194 4.84267 -27.3174 -173 2 17.0439 2.54012 12.3481 -6.98409 -4.39606 26.1758 -174 2 16.4729 1.42155 13.294 0.162444 -0.657512 2.21945 -175 1 2.4659 15.8297 12.1956 27.3811 -11.2673 13.1923 -176 2 2.9226 15.5311 13.0144 -9.82996 7.11615 -19.573 -177 2 2.93231 15.4201 11.4444 -5.86947 6.23921 4.54204 -178 1 16.4361 15.5441 5.94616 -3.08145 19.3328 -8.8947 -179 2 17.3593 15.4783 6.2724 -11.5576 7.7283 -8.52746 -180 2 16.3183 16.2893 5.29043 11.1937 -18.2696 22.1006 -181 1 5.84475 5.01999 11.7951 -3.08481 -3.45829 -4.75382 -182 2 5.52388 5.87345 12.0737 0.2772 11.9484 7.56792 -183 2 5.11411 4.43946 12.0133 1.47645 -8.9756 -0.689037 -184 1 15.224 4.86392 0.726277 -25.4938 -12.7349 25.4219 -185 2 14.7355 4.51715 1.53205 23.492 12.9767 -22.6649 -186 2 14.5328 5.02763 18.7193 1.17802 2.78752 1.94947 -187 1 16.3449 16.2967 2.11437 10.483 7.37611 -22.6614 -188 2 15.9997 16.7982 2.83675 -10.4405 6.50893 22.1211 -189 2 16.6677 16.9984 1.52582 -1.93062 -9.0043 0.169523 -190 1 0.302094 4.87802 3.79689 -13.2533 37.9479 3.00012 -191 2 0.313912 5.8808 3.95538 6.86913 -44.9842 -7.10747 -192 2 1.1462 4.49233 4.0346 3.71094 3.5442 4.02727 -193 1 2.9221 14.9895 15.0397 8.46471 -6.33736 14.5665 -194 2 3.00495 14.6058 15.9566 -9.31495 16.4585 -22.1508 -195 2 2.45729 15.8402 15.0938 1.85721 -3.29548 9.95349 -196 1 1.12 14.5717 9.56227 17.989 48.8934 -19.0037 -197 2 2.07414 14.5222 9.32346 -20.956 -13.4859 7.84449 -198 2 0.791626 13.7731 9.9282 4.87275 -29.8773 11.3577 -199 1 13.6624 16.6636 11.5457 -10.5327 9.77879 -22.0557 -200 2 13.3286 17.4311 11.0186 6.18992 -14.9435 17.5347 -201 2 13.3805 15.8992 11.021 -2.34987 0.215756 7.80532 -202 1 4.73359 1.47857 0.718618 -25.3973 -6.06392 2.87887 -203 2 4.17185 2.00661 0.129453 7.95287 0.81937 2.61464 -204 2 4.09095 0.858388 1.12753 14.212 5.94905 -1.43657 -205 1 1.42476 18.4735 11.9056 -5.99404 19.5083 -8.93412 -206 2 1.23513 0.382953 12.6723 -0.378912 0.915416 0.341246 -207 2 1.89505 17.7259 12.2433 7.21066 -16.1249 4.04173 -208 1 11.5448 10.106 4.11346 25.2596 15.8213 -25.5125 -209 2 11.5283 10.5663 3.22641 -2.70186 -14.3529 26.6987 -210 2 12.5027 10.081 4.37886 -27.2068 -0.404219 -8.52489 -211 1 8.37485 12.1748 3.75184 -11.9448 24.9759 46.3975 -212 2 9.17743 12.5878 4.11803 1.10724 -8.54244 -18.9118 -213 2 7.75197 12.4339 4.49102 7.61965 -18.0915 -33.0697 -214 1 14.3244 4.03247 3.293 11.3964 4.48411 20.4985 -215 2 14.943 4.18459 4.05162 -10.8147 -3.75721 -20.4981 -216 2 13.4909 4.45368 3.55282 4.29688 -1.92648 -2.70238 -217 1 5.58313 1.77339 7.50694 -37.3093 -46.6507 29.7736 -218 2 4.97145 1.12464 8.0478 36.2685 39.0776 -31.448 -219 2 5.37556 1.59155 6.57949 1.79923 3.69516 -0.386563 -220 1 17.9058 1.11523 4.88403 9.14173 18.8744 -7.73144 -221 2 18.4454 1.57607 4.20954 -6.0377 -15.1011 6.62684 -222 2 17.7347 1.81107 5.53023 -2.74058 -7.94095 2.09707 -223 1 6.8279 9.39776 4.48823 3.62694 -0.974221 -6.28613 -224 2 6.84568 9.51125 5.43283 -7.5389 4.30482 14.2207 -225 2 7.717 9.07508 4.31798 2.90721 -0.358573 -8.96695 -226 1 2.70207 14.9601 1.96467 9.48597 -9.94138 -22.1344 -227 2 3.35633 14.7518 2.62888 0.238693 -0.206349 10.2383 -228 2 3.16249 14.7444 1.12616 -13.7934 7.99556 12.9651 -229 1 17.2754 12.8959 13.1352 7.09139 -37.5845 3.69594 -230 2 16.3537 13.1102 13.3148 3.80173 19.6017 -1.81888 -231 2 17.838 13.6507 12.9698 -8.26303 20.1956 -1.14982 -232 1 15.0171 10.5799 1.38486 -27.8548 -28.8799 -20.6854 -233 2 15.5438 11.2121 1.82149 21.7425 28.5078 17.6295 -234 2 14.2994 11.069 0.967203 2.72678 -1.55793 4.42244 -235 1 5.71388 6.94387 4.52744 5.06868 -23.5408 12.0019 -236 2 5.87421 7.87915 4.41499 3.45829 8.88765 -0.888191 -237 2 6.40286 6.63416 5.14703 -8.303 0.627238 -7.76707 -238 1 8.10838 8.26645 10.1831 -2.58942 7.80898 11.2224 -239 2 8.62669 8.8788 9.66253 10.4484 9.83111 7.1505 -240 2 7.63286 7.80673 9.50478 -12.057 -13.4779 -6.03182 -241 1 13.5281 18.2914 5.80176 -22.4215 -1.8227 14.6872 -242 2 12.749 0.212336 5.63336 9.50875 -1.85743 -1.68773 -243 2 13.2346 17.7232 6.55015 8.07385 12.1374 -16.5266 -244 1 0.320637 2.55746 0.113707 -24.4854 52.0087 1.52013 -245 2 18.0083 2.70852 18.6241 7.28296 -16.9077 1.12853 -246 2 0.626424 3.4996 0.197011 8.79214 -31.4205 1.87945 -247 1 12.6453 10.9632 9.76861 -25.4211 42.834 -14.9231 -248 2 11.6492 10.8795 9.70071 37.3368 -7.50244 3.90461 -249 2 13.0228 10.1402 10.0352 -3.08107 -28.1376 6.91694 -250 1 0.78452 12.2807 11.0864 19.7349 -6.9692 -1.93691 -251 2 18.4749 12.3028 11.1225 -11.4863 3.49833 6.83674 -252 2 1.15231 12.659 11.9029 -10.6903 -3.95248 -3.68276 -253 1 5.04293 7.22507 13.482 3.09598 5.99749 -4.73795 -254 2 5.58886 7.93262 13.132 -0.232718 7.71962 -10.0141 -255 2 5.52798 7.00144 14.2755 -0.932575 -7.50807 9.86229 -256 1 1.28071 6.97469 11.8373 -31.3117 -37.3004 -11.5925 -257 2 0.492113 7.17802 11.3051 9.94401 -3.39318 6.90536 -258 2 1.685 7.80152 11.9673 18.2328 34.095 8.03536 -259 1 15.4541 9.47192 12.3133 5.85738 22.5951 5.06509 -260 2 15.5175 10.4638 12.3742 -4.62374 -31.0112 4.63394 -261 2 15.4968 9.06746 13.1992 -1.35817 12.6181 -10.5463 -262 1 16.6442 12.9519 5.45538 -21.4717 15.277 -31.3145 -263 2 16.3435 13.8787 5.41602 10.8128 -9.57177 19.5795 -264 2 16.428 12.7198 4.52965 10.5011 -15.0883 17.3079 -265 1 6.17539 10.0558 0.19339 -10.2788 -9.80575 -26.1597 -266 2 5.38875 10.4515 0.589333 6.07089 -1.52504 2.9393 -267 2 6.86188 10.0925 0.84877 11.0601 2.17112 10.8149 -268 1 12.366 6.05676 4.0416 -22.1854 -19.7968 12.9024 -269 2 12.3704 6.78834 3.44644 3.0333 22.1434 -14.5586 -270 2 11.4296 5.77117 4.03801 16.8285 0.174707 3.6691 -271 1 0.132536 12.8255 0.204274 -0.526736 3.63462 -3.55478 -272 2 -0.0162245 13.5547 0.824079 2.12041 -2.82991 -1.20796 -273 2 18.2367 13.045 18.0704 5.31007 -1.26571 4.82883 -274 1 3.83823 18.58 8.61434 -10.0824 -4.97514 -18.4016 -275 2 3.52069 18.2861 7.74382 9.30441 -4.40092 2.94392 -276 2 3.03757 0.306881 8.974 -6.88025 7.19874 10.2509 -277 1 7.39362 17.2775 4.45212 12.7302 8.58303 13.7229 -278 2 7.99666 17.968 4.81801 -14.6435 -15.1886 -20.2263 -279 2 7.36047 17.3088 3.48385 6.79225 7.50625 8.12072 -280 1 9.21958 17.0373 12.2266 15.7968 3.09867 9.11932 -281 2 9.35553 16.2013 11.7334 2.65662 13.4997 9.89778 -282 2 10.0046 17.242 12.8046 -16.9951 -13.4125 -19.4407 -283 1 13.3157 13.0082 7.94027 -17.3901 -31.9016 7.67948 -284 2 13.1929 12.2449 8.54147 -2.27359 6.97807 -8.06923 -285 2 14.1396 13.3907 8.1966 15.275 17.864 3.60781 -286 1 14.9833 2.94943 15.3513 6.95235 -3.03472 -25.2367 -287 2 14.3042 2.39498 14.9448 0.627233 -0.993788 8.39197 -288 2 15.6656 2.99789 14.6444 -10.442 2.78752 17.6131 -289 1 9.85751 15.5027 17.0048 6.47201 6.54967 -7.92386 -290 2 10.2825 14.6779 16.7304 0.0104739 2.25127 2.62159 -291 2 9.29444 15.3215 17.7618 -3.54568 -3.88732 3.90928 -292 1 11.2881 8.2507 16.5469 4.08161 11.4658 1.26949 -293 2 10.784 7.71518 15.9432 -10.4144 -1.78397 -10.2593 -294 2 11.7122 7.60386 17.1014 6.56418 -3.83522 10.5232 -295 1 3.78473 18.1936 16.723 -4.68023 16.7202 -12.0174 -296 2 4.25527 17.5912 17.2966 7.9068 -1.91441 12.6846 -297 2 3.78787 0.451609 17.087 5.31404 -15.3334 2.54941 -298 1 2.1979 4.10843 8.95106 26.9406 -12.5237 33.2314 -299 2 3.04044 3.62982 8.81286 -17.1971 13.1508 -10.8815 -300 2 2.16124 4.09638 9.93984 -10.9226 5.8942 -24.7105 -301 1 9.90906 10.3512 9.74092 -24.4032 35.3078 2.18412 -302 2 9.42476 11.1784 9.45919 17.314 -27.1904 0.11143 -303 2 9.91744 10.4013 10.7102 5.12409 -5.92526 -7.2544 -304 1 9.73754 0.812356 10.8589 -9.45704 -2.93658 -4.01088 -305 2 9.44076 18.5949 11.1517 4.40065 -9.39685 13.0528 -306 2 9.08713 0.996724 10.1835 0.761981 14.6946 -8.69624 -307 1 9.19301 15.2105 10.2107 -22.2036 -10.0383 -7.82623 -308 2 8.98025 16.0713 9.80369 1.46967 -14.8527 4.99479 -309 2 8.36662 14.6679 10.1029 23.0402 13.9843 6.10558 -310 1 0.991303 9.28993 10.3284 48.5242 0.758788 -7.3086 -311 2 1.23965 10.2015 10.4879 -14.9681 11.3684 1.41472 -312 2 1.89881 8.9146 10.1688 -36.1698 0.796544 3.16897 -313 1 16.8183 4.88742 8.19443 14.5542 -10.1877 33.2312 -314 2 16.1728 5.34475 8.77937 11.7085 -6.30946 -17.3069 -315 2 17.4003 4.3619 8.8005 -18.9368 13.5764 -18.1776 -316 1 14.6428 14.6932 0.395223 -8.43601 -1.47433 8.87339 -317 2 15.0319 15.2579 1.0921 -3.12605 -9.09789 -8.18687 -318 2 13.8519 14.2576 0.787234 16.4944 11.1317 -8.84191 -319 1 3.51972 11.0527 9.63241 -0.0258339 11.398 -8.76826 -320 2 3.50143 11.4368 10.5206 2.13389 -0.105265 -4.21661 -321 2 3.1724 11.7459 9.02999 3.72912 -11.0816 8.2725 -322 1 11.0404 10.8634 1.27208 6.70694 17.4362 -9.49329 -323 2 11.1727 11.6824 0.735781 1.31404 -20.4369 14.6488 -324 2 10.1116 10.6362 1.15363 0.362803 -1.95542 1.92755 -325 1 13.2201 7.06705 12.8916 -20.9652 2.88797 -6.38338 -326 2 14.1438 6.85164 12.9216 15.9393 -3.58362 1.12932 -327 2 12.7477 6.22232 12.897 3.28641 3.49729 -0.863357 -328 1 9.62872 1.89177 0.948251 6.96093 0.24991 16.0649 -329 2 8.76715 2.00519 0.577625 -19.1552 -2.18542 -3.65809 -330 2 10.1854 1.76875 0.19003 12.4655 1.79214 -8.44775 -331 1 10.594 13.5319 4.7375 16.0423 -1.41644 13.6035 -332 2 11.415 13.0379 4.93682 -11.8157 3.93147 -13.4525 -333 2 10.5255 14.1008 5.52348 -3.94863 -4.31219 -11.1546 -334 1 14.2685 1.70153 10.8945 -3.08057 3.85383 7.15216 -335 2 15.0552 1.23258 10.5836 3.50278 10.8149 -1.53255 -336 2 14.4104 2.66429 10.8947 7.37053 -8.35752 -2.77651 -337 1 14.6611 12.4198 11.7249 1.4364 -26.5965 -56.3444 -338 2 15.4897 12.4837 11.202 -5.7241 6.85295 22.6084 -339 2 14.0924 11.9909 11.0313 1.01548 12.4899 31.9742 -340 1 8.24953 5.08668 9.79072 -30.3058 0.287699 22.814 -341 2 7.41708 5.03925 10.3073 16.545 17.0491 -5.32162 -342 2 8.22462 4.2143 9.42755 11.9131 -18.3304 -16.4659 -343 1 1.59402 16.8187 18.3253 -6.20255 31.6963 -6.78121 -344 2 1.91227 17.2067 17.482 -4.95179 -10.2412 13.7563 -345 2 1.83336 15.9037 18.3179 8.32765 -17.6711 -3.36436 -346 1 1.43897 17.2464 15.3358 29.6054 -7.17934 -6.21787 -347 2 1.36087 18.1379 15.637 5.97318 20.4573 7.89508 -348 2 0.556137 16.9475 15.3273 -33.612 -15.1267 -3.09538 -349 1 3.72895 5.57357 6.20543 -8.92972 12.8219 1.61975 -350 2 3.23079 6.21113 6.76482 10.0758 -7.74032 -14.0976 -351 2 4.28418 6.06511 5.5772 -4.67021 4.78615 6.0759 -352 1 12.3529 9.4251 14.1822 19.6727 -43.1834 10.5387 -353 2 12.884 8.61082 13.8993 -22.621 36.8155 4.19437 -354 2 12.0516 9.14148 15.0731 3.60544 11.6456 -14.396 -355 1 4.03531 15.2728 6.90881 24.4865 3.71204 -3.62934 -356 2 3.44033 16 6.68284 5.60112 1.73001 -3.29651 -357 2 4.96253 15.5542 6.68078 -28.8575 -4.96404 7.1648 -358 1 0.605953 8.56457 14.8638 -0.120582 -0.391313 3.99343 -359 2 0.501042 9.52227 15.005 5.35221 -7.46858 -4.68281 -360 2 1.25554 8.44629 14.1506 -6.09669 6.93914 6.70414 -361 1 12.9734 8.36578 10.3368 20.5003 -18.2509 -7.79226 -362 2 13.7393 7.86937 9.99522 -8.8873 10.1321 -9.444 -363 2 12.9708 8.03443 11.231 -10.3099 3.90117 14.6287 -364 1 15.2894 7.6332 3.49269 12.7581 18.2329 -13.143 -365 2 14.5338 7.17315 3.08677 6.1918 -0.800492 21.6775 -366 2 15.5136 7.51531 4.43453 -15.4019 -14.7068 -6.3771 -367 1 17.3212 6.64473 0.0316567 -27.1824 12.6283 -1.8657 -368 2 16.771 5.99448 0.499966 9.26154 0.672542 -4.32476 -369 2 16.64 7.24337 18.2783 17.9792 -11.5061 8.92142 -370 1 8.80668 6.92454 7.83918 -24.3908 -17.2325 7.20576 -371 2 9.68081 7.28212 7.80962 25.7376 5.86496 2.86911 -372 2 8.71775 6.37228 8.64787 6.10597 9.33115 -12.275 -373 1 12.3202 0.615137 1.17425 13.6931 -3.72396 -2.19539 -374 2 13.075 0.992886 1.63957 -0.40119 2.44364 5.09949 -375 2 12.7571 18.5667 0.666384 -10.9298 0.853201 -1.96514 -376 1 5.6785 15.1027 14.5126 8.23045 15.6484 -5.86338 -377 2 4.72039 15.1784 14.5966 0.299323 4.01186 0.94539 -378 2 6.04535 15.9236 14.1081 -12.4379 -14.8055 10.7649 -379 1 3.83406 6.52943 1.68496 -5.12703 10.9404 0.999964 -380 2 3.44824 7.31709 1.2662 3.88585 -11.3877 -2.55221 -381 2 3.84338 6.82178 2.59771 5.33619 -6.06857 7.79227 -382 1 3.88904 11.6132 12.2401 8.95627 -8.79814 -2.40389 -383 2 4.75841 12.0277 12.3683 -7.0992 0.0294616 4.018 -384 2 3.233 12.1226 12.7151 -2.84239 9.6423 6.84851 -385 1 5.44987 3.87776 15.8711 9.04603 51.7105 12.2927 -386 2 5.99752 3.20763 15.4917 15.5436 -17.9801 -7.19396 -387 2 6.04703 4.69158 15.9698 -28.7283 -34.9666 -5.01916 -388 1 14.4605 10.3225 4.39641 11.4537 -30.5762 -31.9722 -389 2 14.8306 9.83502 5.14205 -5.39586 2.29688 2.9797 -390 2 14.6901 9.75629 3.58792 -12.4512 26.4694 34.1579 -391 1 7.94485 17.2962 9.23406 -29.3852 32.3044 -4.90329 -392 2 7.20157 17.582 9.8013 11.6936 -12.8295 -3.21694 -393 2 7.93254 17.9646 8.52624 8.85814 -10.3239 0.926379 -394 1 4.49873 14.4249 3.9575 27.1774 17.1098 41.9883 -395 2 4.83669 15.3326 4.20793 -17.2661 -25.1881 -14.2087 -396 2 4.80599 13.8528 4.71739 -13.53 13.4591 -29.2523 -397 1 14.3284 7.3854 15.7629 16.5671 6.07561 9.97379 -398 2 15.2454 7.23106 15.4511 -19.609 3.15959 8.32151 -399 2 14.4426 7.80786 16.6389 -4.4507 -8.27801 -15.1382 -400 1 2.87403 18.2247 1.90389 13.9577 30.3231 32.1513 -401 2 2.546 17.6397 1.25326 -17.0615 -24.6646 -23.5795 -402 2 2.12038 18.5502 2.43008 9.19244 -2.23706 -9.85686 -403 1 7.96361 1.60549 4.53489 27.0952 14.1367 0.307488 -404 2 7.49638 1.9472 3.77739 -15.4877 0.180801 -4.55719 -405 2 8.8215 2.06687 4.46869 -11.5471 -13.5362 7.94734 -406 1 2.67177 14.1298 17.7578 -32.0965 -17.6674 6.84649 -407 2 1.82063 13.6639 17.9969 26.9839 12.0838 -7.18622 -408 2 3.38659 13.5743 18.1098 -5.52669 6.70603 -3.66321 -409 1 0.723551 1.68725 13.8621 17.7332 3.27009 -2.43746 -410 2 0.829271 1.51069 14.7908 7.98206 -4.95309 12.0999 -411 2 18.44 1.84118 13.7764 -20.4783 4.25661 -8.09669 -412 1 4.55406 18.6 13.9636 17.2604 -7.63309 -9.35161 -413 2 5.43897 18.1924 13.8214 -18.4623 11.1021 3.79828 -414 2 4.32329 18.399 14.8757 -4.15164 0.0521115 2.41255 -415 1 7.10455 0.474046 18.3679 -11.2359 27.2348 29.1061 -416 2 7.12016 0.115813 17.4965 -1.63433 -6.1865 -23.0052 -417 2 6.24271 0.910062 18.5515 12.5771 -12.8936 -7.91243 -418 1 16.1005 18.44 14.1333 -36.4501 -27.5791 -6.57953 -419 2 15.3829 17.8174 13.8465 25.6281 20.8019 -1.7164 -420 2 15.9077 18.5395 15.0719 9.49834 8.44163 -0.14337 -421 1 10.1046 4.52059 16.2893 -46.9792 2.1543 -16.8809 -422 2 11.0012 4.49779 16.5541 31.7343 -4.51398 5.87687 -423 2 9.86248 3.65729 15.9089 12.0807 6.21086 8.83226 -424 1 15.8363 17.9271 4.41684 -16.1004 8.03032 22.5493 -425 2 16.5039 18.6299 4.52246 -8.60661 -6.24751 -1.3813 -426 2 15.0378 18.2098 4.9532 29.0614 -11.0784 -22.6438 -427 1 6.9284 17.3613 13.7353 43.359 11.4946 7.60179 -428 2 7.46858 17.7163 14.5015 -21.3841 -13.8198 -23.6549 -429 2 7.59514 17.216 13.0184 -16.6797 3.36376 18.1603 -430 1 13.2847 6.56451 6.73769 -14.228 -11.1924 -15.3605 -431 2 14.2169 6.67596 6.68467 27.6084 8.49537 10.422 -432 2 13.086 6.40899 5.80997 -14.9004 -1.60425 -0.509451 -433 1 7.67719 2.38409 9.18276 -12.7481 -9.95901 -21.449 -434 2 7.23781 2.34079 10.0234 -2.84678 0.492631 19.9336 -435 2 6.97018 2.11077 8.55354 21.5545 6.86467 6.74712 -436 1 15.1528 14.8764 13.6487 -19.1236 6.62595 6.09279 -437 2 14.9964 15.042 14.5941 6.3649 -1.885 -8.0702 -438 2 14.3208 15.1168 13.2045 14.5757 -4.46306 2.19701 -439 1 9.29857 8.33432 3.70772 10.6355 -8.13532 4.49802 -440 2 10.1502 8.81328 3.76286 -8.0776 -10.0517 2.73632 -441 2 9.46492 7.39019 3.89736 0.427871 14.9166 -2.52044 -442 1 17.6858 13.4785 16.4504 18.1421 12.8824 -2.9019 -443 2 16.7336 13.3749 16.3876 -0.564153 6.32044 -4.53985 -444 2 17.9415 14.3223 16.0098 -13.7235 -15.3212 6.57805 -445 1 5.04165 10.6569 2.59879 15.0811 -13.5005 18.1704 -446 2 5.79991 10.2916 3.10884 -13.8602 3.81488 -12.1379 -447 2 4.57944 11.1735 3.25148 -7.64374 9.33605 4.93504 -448 1 3.71156 8.35988 10.3223 2.69392 -10.4458 7.32 -449 2 3.86762 9.29314 10.1995 2.90356 12.3134 -9.75827 -450 2 3.79851 8.25131 11.2818 -4.19061 -2.88345 -8.87222 -451 1 16.1009 7.11278 6.31821 6.57165 -19.5926 -13.3215 -452 2 16.7556 7.67982 6.75754 -3.32154 -9.30994 -6.24555 -453 2 16.5222 6.22545 6.20359 -10.7974 20.4957 5.39095 -454 1 15.1877 7.01217 9.11633 -0.942582 31.3193 -31.4924 -455 2 16.0087 7.4094 9.45282 -9.93766 -6.26011 -0.320925 -456 2 15.0368 7.51069 8.25256 3.47491 -21.9129 34.3614 -457 1 6.44498 13.1525 12.9077 -4.11711 1.46333 8.37594 -458 2 7.24124 12.6683 13.1519 -1.65948 -2.61146 -1.33868 -459 2 6.29723 13.796 13.6274 -0.63037 -8.66373 -16.4588 -460 1 12.122 4.49686 13.0678 27.186 16.1548 19.2119 -461 2 12.2551 4.61131 14.0219 7.12074 5.87928 -4.56992 -462 2 11.3374 3.99971 13.0395 -36.5276 -21.5475 -13.6693 -463 1 11.3413 8.18743 7.85231 -9.00357 4.77407 0.37365 -464 2 12.0188 7.6639 7.39095 2.25052 4.68793 14.2505 -465 2 11.6381 8.44006 8.74837 5.13859 -10.097 -12.5363 -466 1 17.1781 10.7776 7.41775 8.98079 -10.5429 4.93206 -467 2 17.827 10.053 7.20793 -14.7505 26.0455 -2.01259 -468 2 17.1485 11.4724 6.73654 6.61625 -12.2683 -1.04931 -469 1 5.23072 18.1435 11.0535 -19.1878 -10.0323 -1.26774 -470 2 4.70405 18.0783 11.8789 8.35901 -0.713622 -15.9457 -471 2 4.65273 17.8196 10.3204 13.2116 10.9899 16.482 -472 1 7.5638 17.6255 1.82385 0.18941 -4.57957 5.58349 -473 2 7.78527 16.8134 1.38126 5.66428 -18.4097 -0.230917 -474 2 7.45334 18.2192 1.09148 -1.66074 15.0057 -4.75644 -475 1 1.8616 12.9257 13.6096 9.14642 8.79388 9.51824 -476 2 1.6025 12.3584 14.3568 1.58601 7.25854 -8.04733 -477 2 2.19519 13.7677 13.9951 -8.21693 -20.1216 -3.01678 -478 1 9.73071 6.79429 14.803 -9.96431 20.7294 -5.24946 -479 2 9.965 5.93538 15.1079 4.49059 -29.2435 15.7374 -480 2 10.0131 6.81015 13.8895 1.7202 7.35701 -8.16934 -481 1 15.2073 4.3815 10.7753 5.02149 -7.87008 -1.3136 -482 2 16.102 4.07091 10.8622 12.544 -14.2164 -8.54624 -483 2 15.2461 5.11302 11.375 -14.5847 15.9831 9.57625 -484 1 11.1932 6.12384 0.161263 5.03411 2.82645 3.69768 -485 2 11.3288 5.17786 0.364595 -11.2178 11.9329 -9.49937 -486 2 10.2678 6.33084 18.566 9.25768 -12.2342 6.14633 -487 1 0.186838 11.3278 15.1363 -29.5173 30.1692 -23.1318 -488 2 18.3705 11.8565 14.4078 15.8912 -24.6881 20.4884 -489 2 18.5399 11.8236 15.9183 6.48048 -3.45982 -2.85079 -490 1 7.07004 9.14522 7.26474 -13.1186 -12.9635 8.90657 -491 2 6.53932 8.3872 7.60207 7.2147 19.6305 -8.47997 -492 2 7.95552 8.78183 7.22801 5.51641 0.721385 -0.901037 -493 1 18.4462 15.4465 12.3531 0.397712 -4.42488 4.01328 -494 2 0.764911 15.5581 12.2944 -10.8471 -1.16552 -3.91149 -495 2 18.1036 15.6779 11.4829 2.90793 1.2817 1.1609 -496 1 16.5729 4.36464 5.24677 -25.0478 -7.96005 29.4563 -497 2 16.6771 3.95228 6.15287 5.89012 16.1194 -31.2199 -498 2 17.3789 4.38374 4.73556 17.0857 -2.87844 2.77648 -499 1 17.7776 3.07164 10.7152 20.2072 1.91324 7.6701 -500 2 0.0768882 3.1314 10.9751 -16.1773 7.43675 -1.86825 -501 2 17.7244 2.20926 10.3009 -7.90603 -5.17093 -4.6179 -502 1 12.3097 0.0632784 10.17 -5.23585 14.9609 -0.662134 -503 2 11.3669 0.329281 10.3192 28.4735 0.874848 -0.34084 -504 2 12.8997 0.858518 10.2668 -24.0851 -21.9241 -3.33166 -505 1 10.3626 9.82488 12.3121 10.8795 10.4681 17.7395 -506 2 11.1241 9.87716 12.9295 -11.9387 -4.40292 -9.54779 -507 2 10.179 8.8911 12.2253 1.1465 -9.5921 -0.185536 -508 1 0.479623 2.83009 7.02164 2.3472 21.5918 -9.19818 -509 2 0.779466 3.61946 7.51564 -3.03286 -18.4976 -0.625243 -510 2 0.704445 2.06385 7.54355 5.66126 -3.27927 9.79357 -511 1 0.467007 15.244 6.91284 -2.81724 -38.2268 -9.44322 -512 2 0.589986 15.6097 7.78713 1.11258 -6.7374 10.833 -513 2 0.615386 14.2454 7.00377 -3.57496 47.8567 -6.78063 -514 1 16.9531 7.01102 15.3314 25.0955 -6.26352 -3.35293 -515 2 17.7312 7.54015 15.1398 -4.24099 15.1997 -5.49373 -516 2 17.3882 6.19624 15.5982 -13.584 -8.29127 -0.013797 -517 1 9.00968 12.4205 8.1448 -47.4595 3.97518 -14.6445 -518 2 9.255 11.8265 7.44329 24.3825 -11.7648 -7.05727 -519 2 8.04408 12.5071 7.93332 27.0995 7.32888 21.0703 -520 1 1.26609 1.94093 3.05591 2.05426 9.79258 -12.831 -521 2 1.21698 2.59367 2.33971 -7.6512 -12.9321 3.35408 -522 2 1.90984 2.32941 3.65026 1.81811 -2.05605 5.16186 -523 1 4.13335 15.1162 9.63732 -3.37236 0.94273 -0.929026 -524 2 4.11982 15.1465 8.67375 -6.81504 5.04573 1.04836 -525 2 4.9784 14.712 9.81623 8.98269 -4.0071 9.77097 -526 1 7.18021 2.17978 14.5671 7.55504 9.68183 9.47496 -527 2 6.93575 1.71258 13.7681 -0.50379 0.233559 -6.02908 -528 2 7.66352 2.97784 14.2972 -3.4628 -8.48803 0.116771 -529 1 18.6085 14.7119 2.15295 17.2538 -25.5542 -3.98016 -530 2 0.854482 15.0949 2.23403 -8.04084 1.8593 -0.311551 -531 2 17.9464 15.3611 2.33256 -11.9957 20.7574 3.41759 -532 1 9.94838 2.78838 12.9451 -1.38176 -12.4025 -13.9087 -533 2 9.76343 2.19068 12.1969 8.49761 3.03822 8.73498 -534 2 9.19943 3.38599 12.9407 -2.82035 8.06337 4.45668 -535 1 2.81023 8.91387 13.015 -11.0947 -9.09099 -1.03322 -536 2 3.12702 9.79437 12.8576 7.30933 17.7942 -2.89213 -537 2 3.52626 8.44288 13.432 10.5553 -8.83156 6.15268 -538 1 3.22981 8.35572 3.63929 7.91603 12.3414 59.3292 -539 2 3.55022 9.08279 3.12704 6.39159 12.4302 -19.4578 -540 2 3.47038 8.64809 4.58003 -14.7797 -20.4427 -37.089 -541 1 5.63158 7.19787 8.5111 -16.5836 -10.0318 8.45115 -542 2 5.49703 6.26423 8.32413 12.2862 -3.4998 -5.25722 -543 2 4.92977 7.35667 9.15199 5.58983 12.4707 2.72685 -544 1 14.8806 1.27947 2.01044 -5.20911 -29.6221 -13.7523 -545 2 14.8531 1.98102 2.64457 3.54145 24.2946 3.1913 -546 2 15.2413 1.51873 1.14568 -0.321243 12.6895 5.96264 -547 1 8.23741 15.1928 0.849855 10.5438 9.56485 -11.8122 -548 2 9.03414 15.1092 1.40038 -9.07879 -4.36113 3.60062 -549 2 7.50349 14.6875 1.21874 4.98636 -2.78068 7.26539 -550 1 15.6325 1.34538 7.23629 -19.2726 -10.6819 -7.69516 -551 2 14.9548 0.715658 6.87861 16.0521 20.279 9.35294 -552 2 15.1584 2.15623 7.4957 0.78871 -9.00488 -4.70177 -553 1 4.90948 13.0908 18.526 11.7484 -4.19917 14.2638 -554 2 5.32661 13.1046 0.771936 -5.81675 2.26251 -17.1314 -555 2 5.47193 13.6353 17.9612 2.08739 -3.03703 1.40027 -556 1 15.3444 8.47528 18.1477 10.5782 11.2904 -17.9652 -557 2 15.7712 9.10441 17.5134 -10.1785 -13.1115 16.9911 -558 2 15.2549 8.94211 0.342082 0.277618 5.95495 -1.45242 -559 1 12.072 3.0348 18.3713 9.16845 -16.043 3.97866 -560 2 11.9997 2.53228 0.532204 -11.5106 10.3924 18.501 -561 2 12.5782 2.36842 17.9104 5.62845 7.32417 -26.0863 -562 1 13.2089 12.6783 5.18015 6.63876 -6.29032 2.85699 -563 2 13.7391 11.9795 4.78379 -2.73226 -0.00342211 -8.22979 -564 2 13.3831 12.5487 6.11225 -3.40081 8.86391 8.40941 -565 1 6.04915 7.04527 0.0350485 10.8742 -21.2203 -4.52865 -566 2 6.02805 7.99092 18.6226 -5.46576 23.9499 6.727 -567 2 5.33859 6.76219 0.618839 -5.51003 3.35157 1.33709 -568 1 17.7393 16.0214 15.0094 13.9302 -13.9422 41.059 -569 2 16.9573 16.5339 15.2303 -2.65419 1.12677 -17.6965 -570 2 17.9199 15.9264 14.0844 -11.8828 6.17072 -25.9912 -571 1 13.1897 1.00209 16.5482 9.0285 -11.9403 8.82412 -572 2 14.1531 0.926941 16.6936 -12.5978 2.36886 -2.70952 -573 2 12.8801 0.0805392 16.5939 -0.793518 8.62378 -3.88342 -574 1 11.1147 14.5676 7.20714 13.0879 22.2032 -16.1382 -575 2 10.392 14.3041 7.74555 -20.7251 -13.6554 17.189 -576 2 11.8256 13.9392 7.33494 4.5733 -4.90634 5.95678 -577 1 17.5119 8.63301 2.08454 0.0660302 9.5119 10.6671 -578 2 16.6736 8.51459 2.527 -7.33525 3.37542 8.64387 -579 2 17.5132 7.89769 1.49414 7.23803 -17.2019 -20.825 -580 1 12.3543 7.99739 2.01665 -2.5776 9.38468 -13.8973 -581 2 12.1955 8.87571 1.62365 2.26325 -8.37679 12.9533 -582 2 11.9634 7.39841 1.37453 -1.21895 -7.08079 -1.91625 -583 1 11.8862 14.6191 10.3431 -20.5633 -33.2885 -21.2052 -584 2 12.048 13.7971 9.8109 4.18347 28.6601 18.3667 -585 2 10.9021 14.6739 10.3387 21.4811 7.86907 3.51893 -586 1 6.88785 7.04202 15.6064 18.5625 21.2571 16.3476 -587 2 7.79496 7.28653 15.325 -16.282 -10.9681 -3.58347 -588 2 6.76913 7.58838 16.4136 -4.66142 -14.4555 -17.927 -589 1 8.00173 4.72633 13.4744 30.8534 11.0647 12.2619 -590 2 7.23536 4.76996 12.9314 -21.7993 1.23146 -17.3356 -591 2 8.43981 5.59806 13.3773 -8.25054 -18.6352 3.63378 -592 1 13.408 12.1818 14.2607 -3.38159 -13.7589 -5.77775 -593 2 13.0599 11.273 14.209 4.17969 5.9499 4.9999 -594 2 13.8015 12.3234 13.3884 0.552928 6.09909 4.73433 -595 1 14.8332 9.42219 7.30259 -3.18701 -8.441 -7.55641 -596 2 15.6639 9.86655 7.42287 15.173 5.4083 -0.0492361 -597 2 14.1987 10.0431 7.62107 -17.8235 6.30723 6.71627 -598 1 12.6528 17.0596 3.07812 -8.70602 18.4808 5.33985 -599 2 12.9496 17.4673 3.92869 -9.46791 -7.74089 -22.4319 -600 2 12.0101 17.6853 2.63014 23.5323 -19.7514 22.4129 -601 1 1.16198 7.14088 17.4585 -7.06812 8.47411 -13.2553 -602 2 0.305081 7.19087 17.9183 5.00325 -4.47293 -7.14563 -603 2 1.04973 7.54449 16.5661 0.440843 -6.25707 18.2149 -604 1 12.7703 5.1502 15.6519 20.537 -9.206 9.03076 -605 2 13.4569 4.49661 15.9358 -13.2491 19.9411 -11.3493 -606 2 13.2029 6.02791 15.5919 -0.675517 -15.6076 2.74775 -607 1 2.52973 3.39372 4.98628 -12.5021 24.9114 40.8727 -608 2 1.78336 3.12225 5.60975 27.8197 11.256 -19.0698 -609 2 2.94772 4.23746 5.36491 -19.3389 -38.1774 -13.5008 -610 1 8.3189 11.2987 13.4496 33.0028 -42.3062 59.2485 -611 2 8.52043 10.9592 14.374 -32.1909 27.8732 -26.3694 -612 2 9.06111 10.8351 13.0577 -1.72326 7.29715 -30.1092 -613 1 12.8789 1.33643 13.3362 0.40834 22.0058 -3.21803 -614 2 13.4118 1.44301 12.5159 -13.2456 3.30889 14.5055 -615 2 12.3632 2.16071 13.5095 17.0122 -18.2145 -15.4576 -616 1 6.34323 13.7037 2.15004 -8.90275 3.4942 1.01633 -617 2 5.67068 13.9831 2.80896 17.8093 -8.54249 -8.97759 -618 2 6.94017 13.0667 2.55763 -1.44693 0.407866 6.84109 -619 1 15.9207 6.60938 12.7941 -14.0219 -16.6873 -1.46208 -620 2 16.3665 7.21966 12.2297 10.4548 13.0291 -14.3606 -621 2 16.4032 6.61209 13.6164 4.57404 0.312906 11.3916 -622 1 16.837 0.713429 9.59537 -4.60186 -23.2491 -5.40047 -623 2 16.7766 18.3812 9.76009 1.861 23.059 -1.51736 -624 2 16.4539 0.846132 8.70764 2.52408 0.807103 8.64662 -625 1 6.14677 11.7538 8.37929 1.46343 -38.2042 -1.58984 -626 2 5.28119 11.5099 8.79312 19.6536 2.3972 -11.55 -627 2 6.62627 10.8955 8.13754 -23.51 30.7545 10.2414 -628 1 2.89887 8.61954 0.44521 -58.0253 1.44029 -30.8084 -629 2 2.28026 8.19904 18.4406 35.2092 -5.33136 7.34884 -630 2 2.23436 9.22701 0.790296 19.604 11.6332 17.9417 -631 1 10.1646 10.4607 6.5042 -2.67562 1.82661 -6.4385 -632 2 10.6119 9.73033 6.95167 0.990091 1.19991 -1.59039 -633 2 10.4858 10.4732 5.58284 -1.09389 -1.85789 13.424 -634 1 6.73063 15.6946 6.55447 -0.851851 -4.83477 5.20485 -635 2 7.09829 16.1491 7.32752 1.36873 0.436433 -10.1699 -636 2 7.02842 16.1335 5.74515 1.47904 6.69628 7.42626 -637 1 6.44804 13.1708 5.58287 -3.43311 -13.1021 10.8705 -638 2 6.66139 13.9646 6.07673 2.2473 5.97996 0.728386 -639 2 6.06157 12.5687 6.2363 0.868112 2.44944 -5.20285 -640 1 16.8203 12.5595 9.83963 -1.29973 -13.3798 -26.0882 -641 2 16.9797 11.9255 9.1094 -0.187484 2.38257 16.1818 -642 2 16.6351 13.3676 9.36293 0.809528 9.54538 5.72824 -643 1 6.04152 2.95052 2.84999 -1.13024 -25.4835 15.2707 -644 2 6.4006 3.79327 2.62573 5.01416 22.8678 -12.9444 -645 2 5.58314 2.5656 2.09763 0.434854 2.67004 -8.58918 -646 1 10.9107 3.32852 3.29939 -12.4238 -2.51051 -2.149 -647 2 10.2568 3.99067 3.55961 5.98057 0.0707186 3.553 -648 2 10.4887 2.88551 2.55708 3.841 -3.98893 -4.96007 -ITEM: TIMESTEP -20 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.69334 7.07477 17.9589 0.0661907 -8.15672 -5.93801 -2 2 7.76544 6.892 18.1438 2.06168 0.344835 4.67083 -3 2 8.87494 6.58302 17.1494 0.0923072 2.18051 2.08263 -4 1 18.5724 8.27759 6.8487 9.68108 -9.0135 5.9796 -5 2 0.0748736 7.96696 5.95521 0.0469709 2.78304 -15.7461 -6 2 0.399795 7.62446 7.38749 -2.21574 6.41883 6.02377 -7 1 8.4 18.5641 6.8134 3.87483 8.82198 -0.0595031 -8 2 9.32611 0.166963 6.70047 -3.24105 -1.28376 -0.166563 -9 2 7.89494 0.641414 6.41149 2.5055 -2.76566 0.153015 -10 1 6.59225 1.83896 11.6912 -0.275689 0.302437 5.80014 -11 2 5.92509 2.27303 12.2308 -4.07131 5.9643 -4.10931 -12 2 6.1821 1.00166 11.4658 -1.55571 -7.95905 -4.17259 -13 1 7.1255 5.73378 2.34451 -23.1841 27.0209 10.5427 -14 2 6.64356 6.29382 2.99422 10.5833 -21.9235 -2.45439 -15 2 6.93596 6.23963 1.54379 8.61204 -12.4491 -6.79559 -16 1 16.2118 10.162 16.1238 9.73263 11.3036 -6.58381 -17 2 17.0956 10.2901 15.7587 -2.05967 -6.96031 3.12171 -18 2 15.9212 11.066 16.279 -7.86411 -1.51367 3.55804 -19 1 10.6155 15.0016 2.3147 2.6864 2.11515 1.56294 -20 2 10.6002 14.5314 3.15674 -2.41534 -3.03603 0.679536 -21 2 11.0785 15.8209 2.51731 -0.0195897 0.981381 0.0978469 -22 1 17.1585 8.25197 10.4305 1.44624 0.93325 5.78222 -23 2 16.6499 8.94547 10.8694 -0.557047 -3.86734 3.9084 -24 2 18.0092 8.65295 10.2197 -0.225121 0.250414 -1.13708 -25 1 14.8741 15.8852 16.3481 -7.08493 -6.82471 0.413246 -26 2 13.9679 16.1979 16.3007 -7.09092 5.8218 -2.34027 -27 2 14.8494 15.2418 17.0641 6.82868 3.48864 5.90805 -28 1 12.1588 13.3817 0.433178 -6.27467 12.7595 -4.80914 -29 2 12.0352 13.6324 18.1551 4.79076 -7.76922 -3.88045 -30 2 11.6846 14.0735 0.910169 -3.08866 -6.36125 10.7585 -31 1 9.27449 5.40778 4.04397 -13.9365 -16.0184 3.55858 -32 2 8.80012 5.02015 4.81047 7.30704 13.9384 -9.37026 -33 2 8.62496 5.33174 3.3181 9.32114 8.483 4.67507 -34 1 1.82732 4.26294 11.6464 -4.04254 -2.69427 0.93532 -35 2 1.77693 5.20244 11.8864 -0.000737327 -7.07977 -0.141665 -36 2 2.24287 3.78422 12.3753 -0.858945 2.71416 -2.4423 -37 1 1.98268 6.82933 8.36887 -4.76513 2.22844 -15.7156 -38 2 2.36253 7.23451 9.15103 4.34961 -4.46197 5.21996 -39 2 2.01952 5.87123 8.47722 1.07428 0.125821 9.68028 -40 1 5.39566 4.39684 7.93565 8.0799 8.40992 8.79829 -41 2 5.46014 3.43633 8.01893 -3.87159 0.552259 -10.4859 -42 2 4.76986 4.63893 7.2446 -2.8004 -4.28351 -0.196723 -43 1 3.26324 2.92599 17.538 -6.48526 11.4036 5.90093 -44 2 3.9521 3.41084 17.0519 -4.33162 -2.5567 2.49087 -45 2 2.74469 3.58038 18.0606 14.1441 -6.64194 -12.4081 -46 1 7.47828 5.27232 6.10849 -6.04695 1.38866 -9.34596 -47 2 7.88111 5.94624 6.68322 -4.96979 -11.9122 3.47667 -48 2 6.82246 4.73008 6.58045 9.57964 11.031 7.72945 -49 1 9.77144 7.02208 11.9904 4.73189 -1.1383 -1.06285 -50 2 10.3467 6.38126 11.5734 3.30689 -2.46386 0.831607 -51 2 9.14216 7.24941 11.3005 -7.52384 3.80108 0.31383 -52 1 14.0798 3.55416 8.05513 -3.28328 4.35009 -1.93857 -53 2 13.7004 4.26501 7.52877 0.673114 -0.544944 -0.0617854 -54 2 14.5392 3.99696 8.77439 -0.252332 -0.945414 2.55344 -55 1 4.73763 17.2389 4.01031 -0.321378 8.61877 -17.0141 -56 2 5.59566 17.6635 4.11691 -0.835388 -5.76098 7.55997 -57 2 4.38449 17.6475 3.19969 -7.45685 -7.93836 11.3283 -58 1 16.5107 16.6056 10.0759 6.54448 8.81329 9.76337 -59 2 15.9397 16.7408 10.8388 -5.01232 -5.78767 -1.53078 -60 2 15.9723 16.2069 9.3894 -4.78788 -4.31379 0.495659 -61 1 1.96746 4.90416 0.450775 -1.81832 7.5424 0.20662 -62 2 2.57813 5.33173 1.07474 -1.76589 -7.7088 -3.71938 -63 2 1.58349 5.65244 18.6136 5.80255 -6.17515 -0.843526 -64 1 11.7761 13.343 16.2841 -6.04701 8.80367 11.8739 -65 2 11.2992 12.5177 16.4849 4.5736 1.77316 -11.3497 -66 2 12.2862 13.2596 15.4658 -7.12668 -12.5479 1.29578 -67 1 10.1128 11.0591 16.9331 1.69597 -16.074 1.546 -68 2 10.529 10.1874 17.0807 -3.30995 11.3925 -3.21813 -69 2 9.18388 10.849 16.7697 3.68635 3.27029 -1.84825 -70 1 11.7127 17.5197 13.4648 11.3019 2.11475 -5.22831 -71 2 12.331 17.0869 12.8651 -0.203424 -4.77186 2.96515 -72 2 11.9976 18.4453 13.422 -5.71015 -0.897636 4.76739 -73 1 6.35333 9.30557 12.2266 11.9787 8.60001 -4.91149 -74 2 6.91868 9.08658 11.4768 -7.06745 -10.6307 -2.02859 -75 2 6.87303 9.9972 12.642 -2.68502 3.03115 9.09234 -76 1 16.2229 12.7446 2.69624 -0.291567 -17.1772 2.14859 -77 2 17.0444 13.127 2.38556 1.82795 9.93981 0.639945 -78 2 15.5737 13.4355 2.84522 -0.398116 10.9003 -3.52894 -79 1 0.630414 12.571 5.87324 -2.78001 5.23525 -2.09291 -80 2 1.00794 12.4159 4.99822 -5.49855 2.79722 0.151968 -81 2 18.3568 12.8603 5.70082 10.405 -7.04854 2.54099 -82 1 5.20787 16.4001 18.4776 -12.5497 0.602195 -7.10426 -83 2 5.86464 15.8156 18.076 4.18722 4.70251 6.39081 -84 2 5.5918 16.9091 0.552483 9.38889 -4.76533 -0.723228 -85 1 0.52849 7.63403 4.08589 29.1287 17.8407 -12.6947 -86 2 18.5836 7.90722 3.36083 3.6478 2.13346 8.06342 -87 2 1.42012 8.03877 3.86645 -30.4536 -16.431 6.17599 -88 1 3.1381 8.91119 6.51072 -13.5755 -1.26875 13.9192 -89 2 3.59199 8.61596 7.312 -0.196935 0.713487 -8.34602 -90 2 2.19086 8.84537 6.73861 12.9731 1.00292 -6.41375 -91 1 7.31254 10.3111 16.1924 3.71601 3.69021 9.41051 -92 2 6.5835 10.5117 15.6001 -2.45726 -1.05124 6.16708 -93 2 6.97924 10.3433 17.1122 -4.5268 -1.10556 -13.1914 -94 1 11.1003 1.05051 4.99797 5.80988 -5.62906 14.1745 -95 2 11.3837 1.86623 4.56736 -9.38615 -1.44268 -8.87945 -96 2 10.7526 0.427875 4.34338 1.37635 7.2616 -4.61902 -97 1 4.41216 2.72626 13.196 4.39031 -15.812 27.2385 -98 2 4.68873 3.14242 14.0209 1.29771 13.5884 -6.24163 -99 2 4.35373 1.80262 13.5146 -5.93981 4.62314 -19.463 -100 1 8.39633 10.0477 1.8021 8.65231 5.58991 3.9521 -101 2 8.43584 10.7505 2.47552 -3.18527 -5.8592 -1.95349 -102 2 8.78245 9.25294 2.20632 -6.17245 6.11296 -0.869653 -103 1 10.5167 1.74791 15.5607 -12.987 -0.969766 6.95693 -104 2 11.4294 1.4693 15.6846 2.64548 4.13814 -6.20872 -105 2 10.3497 1.97094 14.6365 5.88046 -1.13362 -2.56443 -106 1 2.75172 12.9341 7.77038 -1.98364 -2.25212 -7.11701 -107 2 3.34024 13.5411 7.30753 1.72417 1.81116 5.40918 -108 2 2.20386 12.578 7.06153 -5.53374 1.90184 4.06344 -109 1 3.65904 11.6762 5.27167 1.4745 3.00351 -5.43274 -110 2 3.4246 11.0613 5.97769 -1.9036 -0.651658 -6.95213 -111 2 2.87422 11.8691 4.73548 4.37313 -4.77202 2.40024 -112 1 6.8497 14.4837 16.8623 -7.20011 -2.9268 7.54224 -113 2 7.64382 13.9472 16.8068 -1.68272 1.48794 -3.62778 -114 2 6.45279 14.5388 15.9848 5.36951 2.03983 -1.60361 -115 1 14.1732 14.5515 3.40534 8.00808 -4.71428 -5.83886 -116 2 13.686 15.3662 3.26714 -6.11485 0.946493 -0.0166146 -117 2 13.6673 13.9759 3.98664 -1.2314 3.40033 5.39954 -118 1 8.29912 18.1674 16.0589 -20.5282 -4.34905 -0.197762 -119 2 8.7408 17.3576 16.3653 13.9085 14.9544 -3.06277 -120 2 8.83266 0.312858 15.8727 12.6636 -13.3116 3.05514 -121 1 4.73053 1.62244 4.91728 3.73461 17.8941 -9.82498 -122 2 3.87083 2.07692 4.90413 8.70323 -5.84393 3.64668 -123 2 5.31846 2.19299 4.38363 -11.3635 -9.88313 3.69576 -124 1 15.0998 12.7921 16.4359 -16.5392 5.6559 5.83964 -125 2 14.613 13.1569 17.1797 9.93151 -3.40376 10.0434 -126 2 14.4182 12.7815 15.762 4.3611 -9.31248 -14.0367 -127 1 15.7898 18.3971 16.8042 5.79346 -1.22695 27.8179 -128 2 16.3329 18.5498 17.6117 -9.65553 4.21222 -20.1346 -129 2 15.4648 17.4968 16.9407 3.00983 3.14177 -9.23088 -130 1 1.14588 1.15091 16.5513 6.84042 -4.63386 -6.55399 -131 2 1.94328 1.67743 16.706 -5.62204 0.173811 5.06431 -132 2 0.528577 1.37004 17.2554 5.0728 5.5861 0.922174 -133 1 18.0913 4.5707 15.884 4.25376 -5.47852 -1.15194 -134 2 18.5654 4.01411 15.2573 -2.45188 0.25544 1.09753 -135 2 18.6545 4.64521 16.6589 -1.38654 0.113736 -2.45626 -136 1 12.2253 16.9711 16.1412 0.914186 -11.4555 3.91466 -137 2 11.5632 16.3741 16.5429 5.70701 14.4982 -7.43821 -138 2 12.0767 16.9746 15.1851 -6.52552 1.11271 2.73005 -139 1 15.9091 2.53324 17.9911 -0.813861 17.5084 -1.21546 -140 2 15.6764 3.36649 18.4268 1.17892 -6.2644 3.50604 -141 2 15.6868 2.72575 17.0644 4.5424 -10.5093 4.50867 -142 1 6.70264 13.8034 10.241 3.67042 13.5267 -3.47207 -143 2 6.65382 13.63 11.1889 -2.71481 -10.4168 -1.32753 -144 2 6.64075 12.981 9.74212 -1.13183 -3.39045 4.84834 -145 1 10.1303 18.2368 2.79334 3.88934 4.25391 -9.05815 -146 2 10.3528 0.228802 2.09034 -3.74927 -2.61302 6.3793 -147 2 9.24556 17.9143 2.58077 2.23777 4.46644 1.38681 -148 1 2.97822 17.7592 6.09436 6.84514 -11.0569 -16.6755 -149 2 2.2147 17.6257 5.53291 -18.2595 3.26089 9.16469 -150 2 3.66284 17.6557 5.427 11.9633 8.77303 4.67614 -151 1 12.5626 16.9639 7.98676 12.5848 -1.11028 -8.52053 -152 2 11.8839 16.2724 7.94525 -2.9484 9.81966 4.92503 -153 2 12.3706 17.6612 8.63222 -7.85492 -11.7975 4.91014 -154 1 14.885 15.2749 8.26678 1.09184 -13.1129 19.8008 -155 2 14.1202 15.8628 8.27106 1.10724 6.83397 -10.769 -156 2 15.4286 15.3633 7.48102 -5.52588 8.50153 -14.3957 -157 1 17.5862 18.2834 0.376986 -24.9344 -1.23553 -1.17468 -158 2 18.3469 17.8479 0.005767 18.8411 -2.89863 0.907383 -159 2 17.8259 0.448151 0.831731 10.0339 0.947456 -0.506579 -160 1 0.885899 10.3809 1.40397 7.22911 -11.5028 6.53987 -161 2 0.114071 9.81378 1.55479 0.851643 9.57639 -0.353744 -162 2 0.635753 11.1007 0.824785 -9.84019 7.34982 -5.0696 -163 1 1.59112 12.2023 3.3355 8.42913 -7.93475 21.5428 -164 2 1.38243 11.4488 2.766 -0.926106 10.11 -6.99043 -165 2 1.6499 13.0233 2.84482 -2.64968 -0.879455 -11.853 -166 1 0.551086 17.2511 4.8776 21.276 -3.63263 -24.3978 -167 2 -0.0762795 17.9651 4.97462 -6.3407 4.63135 13.3725 -168 2 0.558623 16.612 5.58807 -10.7338 -2.48853 14.1039 -169 1 1.11389 0.976548 9.40441 -9.70348 2.26791 0.52143 -170 2 1.20067 0.739298 10.3296 11.5619 -5.66825 6.05541 -171 2 0.194683 0.747268 9.24308 -0.993818 -3.51563 -8.196 -172 1 16.7801 2.33697 13.2827 1.26658 -2.58515 -3.42214 -173 2 16.9917 2.52603 12.3542 -2.2694 -1.44301 7.47438 -174 2 16.5315 1.40163 13.3451 -1.6586 3.84983 -3.29893 -175 1 2.50653 15.8317 12.198 6.9942 0.0378495 -5.39106 -176 2 3.03319 15.4932 12.933 -2.33393 0.151651 -5.20129 -177 2 2.92041 15.5438 11.3652 -1.63849 1.19534 6.62391 -178 1 16.4211 15.5676 5.95733 20.9565 28.2944 1.83954 -179 2 17.3426 15.5843 6.27645 -8.81355 -7.9692 1.26231 -180 2 16.3612 16.4166 5.46885 -9.28613 -17.0928 2.60564 -181 1 5.82453 5.03389 11.7824 5.33446 0.320875 1.57619 -182 2 5.57998 5.74431 12.3877 -7.39983 3.16893 -2.12011 -183 2 5.27405 4.27426 12.0034 -1.54313 1.61628 -0.196815 -184 1 15.2115 4.85871 0.718957 -12.3292 -1.21553 20.1953 -185 2 14.9951 4.64926 1.65891 1.99725 2.35951 -19.8125 -186 2 14.3839 5.18637 18.9796 8.05664 -2.8997 2.32554 -187 1 16.3489 16.3233 2.11444 -1.37403 -13.232 -8.15517 -188 2 15.9103 16.7203 2.87049 4.10511 7.42013 3.0617 -189 2 16.5474 17.0218 1.48672 0.743353 6.63736 2.3016 -190 1 0.282027 4.87119 3.80055 19.2835 17.3487 3.53091 -191 2 0.489613 5.83173 3.76503 -11.8967 -17.4303 3.14809 -192 2 1.11089 4.48306 4.11838 -9.18259 -2.61174 -2.176 -193 1 2.9303 15.0125 15.0392 0.0573492 -0.181072 31.7668 -194 2 2.82615 14.584 15.9186 6.41531 2.15453 -14.4377 -195 2 2.5906 15.8967 15.228 -6.81336 0.182398 -11.4579 -196 1 1.12223 14.6049 9.5632 13.1187 -18.7351 -0.898815 -197 2 1.97867 14.3698 9.19328 2.71847 14.7063 -6.21023 -198 2 0.940175 13.7592 9.98602 -14.9991 7.00648 6.43026 -199 1 13.665 16.6454 11.5316 -21.8339 3.0331 3.55613 -200 2 13.1746 17.4327 11.223 10.4467 -7.06131 -5.36321 -201 2 13.1002 15.9021 11.2581 8.49503 1.30575 -4.9094 -202 1 4.71709 1.47693 0.719081 -0.792104 -2.26487 7.67979 -203 2 4.13723 2.08795 0.242023 0.0358417 -6.61504 -0.0652634 -204 2 4.16248 0.903426 1.27536 -1.89276 3.42768 -9.42283 -205 1 1.43372 18.4947 11.8904 0.435024 0.903574 -5.06079 -206 2 1.25876 0.369488 12.6813 0.171373 0.403899 4.07674 -207 2 1.76959 17.6363 12.1756 0.0129122 3.12302 0.145238 -208 1 11.5344 10.1145 4.09755 11.0508 4.0163 -22.2825 -209 2 11.4066 10.5292 3.21014 2.38528 -6.34716 18.1192 -210 2 12.5036 10.0411 4.22804 -15.2135 3.993 -1.98571 -211 1 8.36281 12.1777 3.74701 -13.1943 -6.81146 -12.1909 -212 2 9.18722 12.6378 3.9579 -8.09176 1.3179 12.2751 -213 2 7.70079 12.2682 4.46238 18.0882 5.10492 -3.45512 -214 1 14.3344 4.02288 3.28855 15.2498 3.93213 6.6836 -215 2 15.0617 4.23514 3.91062 -12.0049 -4.72392 -3.76747 -216 2 13.5379 4.47251 3.60621 4.75183 0.0120405 -3.02562 -217 1 5.58434 1.74596 7.50985 -22.3692 -26.8297 9.12948 -218 2 4.91823 1.11394 7.92632 27.2868 23.8434 -15.8784 -219 2 5.43743 1.67946 6.54893 -3.28939 1.24453 9.56906 -220 1 17.9012 1.11073 4.88195 -3.31078 -7.47428 -4.80941 -221 2 18.5525 1.45486 4.25184 -3.70144 3.91348 6.86656 -222 2 17.7599 1.74881 5.59037 4.24211 2.13046 -3.7457 -223 1 6.8304 9.4053 4.48372 -13.6803 0.789023 -7.06041 -224 2 6.74666 9.48009 5.43928 9.48337 1.88908 4.46236 -225 2 7.74899 9.21301 4.27057 2.55497 -2.6247 5.048 -226 1 2.68932 14.9418 1.9668 -6.12139 1.43036 2.89635 -227 2 3.30587 14.7185 2.6759 1.77318 0.618157 -6.66396 -228 2 3.15681 14.9246 1.12432 2.70839 -4.47578 5.21755 -229 1 17.2859 12.889 13.1454 -5.46423 18.1991 -4.92566 -230 2 16.4361 13.3067 13.278 -15.9577 -14.9195 9.16742 -231 2 17.7285 13.6846 12.8505 24.3586 -1.49654 -2.29875 -232 1 15.0069 10.5712 1.38624 -2.11062 -3.1818 -0.491761 -233 2 15.5786 11.255 1.74854 2.03128 0.359313 2.4477 -234 2 14.2323 11.0405 1.08579 -5.34855 2.20107 -0.889893 -235 1 5.70672 6.90314 4.53443 4.24519 -5.28557 8.89432 -236 2 5.96576 7.83558 4.52332 0.860976 -3.32444 -1.54743 -237 2 6.34045 6.45199 5.11743 -0.773999 0.740319 -5.54545 -238 1 8.07933 8.28074 10.2171 -3.64639 -3.67369 23.1077 -239 2 8.76707 8.87858 9.90894 -2.7343 3.77639 -10.7375 -240 2 7.6749 7.81667 9.48055 2.86655 5.40525 -7.79011 -241 1 13.5084 18.3075 5.79227 -0.609935 12.5659 -0.945985 -242 2 12.8781 0.387145 5.63591 -2.7451 -9.905 0.332396 -243 2 13.1846 17.8335 6.57076 -1.7745 -1.29433 -5.46225 -244 1 0.277736 2.58212 0.118598 0.621477 -2.00702 8.56184 -245 2 17.957 2.7127 18.6839 10.2871 11.0559 -0.501636 -246 2 0.794319 3.38844 0.33639 -19.4232 -4.52538 -3.88061 -247 1 12.6801 10.9983 9.7602 -12.9965 -11.6862 -0.561246 -248 2 11.7228 10.8953 9.6485 6.19444 12.5166 -3.56604 -249 2 12.897 10.0826 9.9647 14.0656 0.707903 4.64438 -250 1 0.781933 12.2574 11.0872 -6.04901 -2.18816 6.07288 -251 2 18.4712 12.3682 11.1342 -4.62852 -2.97634 -7.25325 -252 2 1.06266 12.4852 11.9795 7.76729 1.60409 -2.26455 -253 1 5.05561 7.24886 13.466 -11.4852 -6.03635 -4.86876 -254 2 5.50236 8.03712 13.1394 10.7241 -0.576345 -1.34855 -255 2 5.49314 6.97472 14.2774 5.89817 7.37955 3.96262 -256 1 1.26581 6.94402 11.8396 4.62667 -0.613543 7.50244 -257 2 0.504801 7.20295 11.3208 -2.84364 2.86798 -1.49635 -258 2 1.66495 7.76854 12.1529 -2.34869 -3.61795 -5.23307 -259 1 15.4733 9.48228 12.3076 -4.70583 25.6475 16.0975 -260 2 15.3149 10.4406 12.4106 2.52372 -12.0579 -11.0564 -261 2 15.3983 9.16189 13.2139 2.67764 -6.7615 -6.72177 -262 1 16.6336 12.9201 5.4628 6.66579 -20.8603 16.0577 -263 2 16.5173 13.872 5.54201 -7.55482 0.841067 -13.5204 -264 2 16.4587 12.5944 4.56908 -1.3904 13.4091 -1.6671 -265 1 6.18458 10.0203 0.145227 10.7922 -3.52818 2.39688 -266 2 5.51531 10.431 0.700604 -4.05423 0.759005 -2.7608 -267 2 6.99302 10.1148 0.667984 -1.67417 -4.19008 -1.28624 -268 1 12.3589 6.06668 4.038 0.452115 -1.15559 12.336 -269 2 12.2616 6.902 3.56852 -2.7325 -0.676505 -9.18667 -270 2 11.4806 5.67315 4.10483 0.607886 2.8799 -4.57435 -271 1 0.151536 12.8218 0.203335 4.13456 -2.94622 -2.33064 -272 2 -0.0129983 13.5003 0.871422 4.06521 1.52419 -2.90371 -273 2 18.34 13.1254 18.0507 -1.07008 -0.669132 2.22617 -274 1 3.8124 18.585 8.59267 3.71655 -0.510361 5.11861 -275 2 3.56708 18.0759 7.80793 -6.58546 5.02297 1.51156 -276 2 3.01311 0.371537 8.92178 -4.29721 -3.94788 -5.16471 -277 1 7.41673 17.2735 4.46563 5.27699 16.8729 -12.8498 -278 2 7.96434 18.0381 4.66458 -2.5447 -1.66977 13.1327 -279 2 7.34622 17.3735 3.5102 -3.86431 -11.0257 -0.167405 -280 1 9.22722 17.0589 12.2393 19.2623 -14.5641 0.108859 -281 2 9.27149 16.2912 11.647 -4.87121 6.1965 2.03703 -282 2 10.0709 17.0037 12.729 -13.5572 10.6592 -2.64279 -283 1 13.3059 12.9585 7.95053 -5.93488 5.61094 -2.56551 -284 2 13.3162 12.2379 8.59837 1.79032 5.44422 0.740585 -285 2 13.8923 13.6822 8.21069 6.53108 -7.176 5.15054 -286 1 14.9676 2.9565 15.3436 -0.386658 0.574387 3.68052 -287 2 14.4202 2.18777 15.1252 1.77471 7.19316 -4.43588 -288 2 15.6633 3.03092 14.6718 -7.27619 -4.52831 0.823712 -289 1 9.86266 15.5244 17.0043 3.51131 -4.56125 -2.22878 -290 2 10.4016 14.759 16.7592 -3.4195 -0.793849 -1.98877 -291 2 9.23782 15.2217 17.674 1.65588 4.18023 5.21634 -292 1 11.2982 8.26605 16.5436 5.00814 15.3472 3.18516 -293 2 10.6561 7.79454 16.0057 0.999826 -4.04983 -0.0472571 -294 2 11.6606 7.65108 17.1873 -4.09078 -4.29715 -0.00155616 -295 1 3.81225 18.1964 16.7292 10.4788 2.16731 8.30533 -296 2 4.28955 17.5863 17.3008 -0.586781 -10.0924 -3.62086 -297 2 3.8829 0.368785 17.226 -6.17555 6.78007 -4.03101 -298 1 2.19803 4.12169 8.95254 -8.42555 5.0907 -8.8117 -299 2 3.07539 3.82533 8.67919 -2.6088 -0.1453 11.8715 -300 2 2.06404 4.00225 9.90658 13.5851 0.597917 -5.47855 -301 1 9.88178 10.3569 9.73038 4.79618 9.75255 -1.56513 -302 2 9.58096 11.2105 9.34815 0.270313 -13.7408 11.2463 -303 2 10.0884 10.4563 10.6769 -5.68787 3.60286 -6.41077 -304 1 9.72212 0.809424 10.8539 19.6856 13.2875 8.50656 -305 2 9.35568 18.6419 11.2241 -8.56647 -0.801274 -6.22283 -306 2 9.1718 1.19131 10.1642 -10.1616 -7.34852 -1.36201 -307 1 9.20808 15.1775 10.2123 -15.4381 -3.13199 6.73164 -308 2 8.85567 15.9769 9.80113 1.42232 -2.21967 -3.83769 -309 2 8.41617 14.6283 10.3808 11.8702 3.92611 -8.2586 -310 1 0.995689 9.3369 10.3259 -16.0333 -0.722577 -1.64132 -311 2 1.04111 10.3025 10.3672 11.5337 -2.90556 1.12718 -312 2 1.85551 8.94205 10.1494 2.50931 13.4523 1.23502 -313 1 16.8622 4.87275 8.19393 -0.422934 0.254968 7.2846 -314 2 16.1689 5.44633 8.57547 10.3862 -6.79292 -0.962882 -315 2 17.2033 4.29721 8.90095 -5.62498 7.92604 -8.45296 -316 1 14.656 14.7011 0.368319 0.981504 1.6367 -2.03469 -317 2 15.1464 15.0731 1.12238 -4.61865 -0.709772 -8.09446 -318 2 13.8079 14.3976 0.718239 6.88081 -1.79732 0.157513 -319 1 3.54139 11.054 9.61635 4.40574 2.25524 -6.23941 -320 2 3.65641 11.5568 10.4349 -3.33961 -4.79202 -0.629126 -321 2 3.06202 11.6341 9.00365 5.95536 0.511998 4.3162 -322 1 11.0657 10.8474 1.29636 2.92174 -3.12366 4.90686 -323 2 11.2982 11.6263 0.767958 -3.5102 -3.65436 5.75862 -324 2 10.1232 10.6698 1.15822 5.54645 2.63321 -1.67034 -325 1 13.2072 7.07995 12.8701 -0.715054 4.17079 -6.48984 -326 2 14.1512 6.89692 12.9697 -2.29399 1.70307 -2.36257 -327 2 12.7789 6.22148 12.7926 -0.519741 -2.64677 3.01569 -328 1 9.62848 1.89714 0.960589 0.144249 -1.27383 8.14422 -329 2 8.75389 1.7191 0.595255 2.62606 0.878667 -4.42234 -330 2 10.2646 1.96201 0.242782 -4.84565 1.17493 -5.89222 -331 1 10.5889 13.5223 4.7138 2.80012 2.67941 -15.7349 -332 2 11.4734 13.1444 4.59356 -4.0194 -1.02806 11.2737 -333 2 10.6142 14.0248 5.53615 3.92037 -3.05166 -0.671 -334 1 14.2891 1.71547 10.914 14.736 9.54636 -9.28817 -335 2 15.0906 1.40219 10.4788 -2.27816 -10.6125 3.67971 -336 2 14.438 2.66833 10.8812 -8.3278 1.7804 6.62982 -337 1 14.6539 12.3888 11.7057 -9.85382 -5.79197 9.84531 -338 2 15.5174 12.4906 11.2689 -13.4179 -5.72309 -9.10321 -339 2 13.9464 12.0325 11.1297 19.1264 4.07718 -1.67851 -340 1 8.24463 5.07042 9.80489 8.67652 16.3821 0.210642 -341 2 7.41075 5.25266 10.2586 0.116202 -10.888 -2.54867 -342 2 8.19641 4.23298 9.33202 -10.3006 -5.74151 5.58561 -343 1 1.57762 16.8331 18.335 1.68687 -2.26048 -0.033424 -344 2 1.80587 17.1847 17.4697 -0.252498 3.71983 1.68741 -345 2 2.01633 15.9753 18.3429 -7.29056 -3.61139 0.997127 -346 1 1.4432 17.2346 15.332 2.65894 -7.35401 -5.7102 -347 2 1.56202 18.0921 15.7447 -7.04866 6.37518 1.22888 -348 2 0.495246 17.0477 15.225 10.7628 4.03376 7.259 -349 1 3.71499 5.60328 6.17396 -2.46237 18.0728 1.59518 -350 2 3.14409 6.20568 6.67532 2.19379 -7.75625 0.984178 -351 2 4.32024 6.21155 5.72591 -1.08806 -7.05296 -5.84211 -352 1 12.3532 9.43776 14.1893 13.0079 -11.8089 -5.25996 -353 2 12.7562 8.63341 13.7793 -8.52026 15.4152 14.9752 -354 2 12.1872 9.21442 15.1219 0.0848175 -4.0166 -10.4276 -355 1 4.03165 15.279 6.91423 11.4052 5.55751 -7.84178 -356 2 3.54353 15.996 6.48767 -3.99323 -1.71496 7.04649 -357 2 4.96733 15.4866 6.74143 -6.91754 -4.3684 4.91577 -358 1 0.598678 8.56195 14.8837 5.20406 11.6905 0.774862 -359 2 0.593362 9.51845 15.0326 -4.59172 -3.85379 3.33684 -360 2 1.20863 8.47913 14.1435 0.530109 -4.80423 2.60663 -361 1 12.9822 8.33824 10.332 -12.7812 8.13505 -15.7365 -362 2 13.7449 7.91273 9.91994 1.65618 -4.07378 8.99333 -363 2 12.9305 8.07685 11.2552 9.52621 -6.7264 2.9301 -364 1 15.3077 7.66451 3.49902 -16.235 -26.2008 20.478 -365 2 14.5457 7.14577 3.24297 -4.72624 11.0142 -23.2354 -366 2 15.4625 7.21195 4.33822 21.3334 18.0327 3.91528 -367 1 17.3129 6.65992 0.0418436 1.52354 1.06354 -1.27952 -368 2 16.9014 5.84978 0.373955 -3.48337 6.90323 -1.87832 -369 2 16.58 7.23266 18.3971 4.62858 -6.17573 2.16922 -370 1 8.83009 6.92284 7.82744 0.252992 -5.92817 5.57761 -371 2 9.76137 7.15634 7.81451 4.22584 7.3373 -3.58966 -372 2 8.73794 6.33872 8.59756 -2.97854 -0.622916 -4.66555 -373 1 12.3396 0.625886 1.18148 -8.16379 -0.652746 9.01197 -374 2 13.1345 0.755236 1.71568 4.24005 -1.61972 -8.33969 -375 2 12.5055 18.5332 0.58867 3.80642 2.13695 -0.293066 -376 1 5.66619 15.1148 14.5143 -6.5884 11.0519 3.391 -377 2 4.74474 15.2404 14.7783 -0.0534379 -6.99417 -3.01637 -378 2 5.9729 15.9975 14.2655 4.1321 -4.56061 -2.72375 -379 1 3.84883 6.51764 1.70764 -0.24517 -12.2729 -5.84301 -380 2 3.34882 7.24325 1.31145 3.38543 6.95106 5.25371 -381 2 3.97654 6.73657 2.63696 -3.88246 4.168 -0.0932901 -382 1 3.88114 11.6142 12.2659 5.57001 4.81087 6.19714 -383 2 4.75444 11.9544 12.4977 1.45427 -2.38077 -3.49117 -384 2 3.27884 12.2304 12.6965 -5.21243 -4.02352 0.863052 -385 1 5.43603 3.86764 15.8623 7.54926 19.6814 5.52869 -386 2 6.13377 3.21124 15.7334 -3.30504 1.34649 -4.68995 -387 2 5.89589 4.73554 15.9355 -10.2176 -19.0214 -2.32011 -388 1 14.4546 10.3201 4.4055 -4.6195 -17.8145 -6.66778 -389 2 14.5894 9.8066 5.2203 1.29615 2.58376 -6.73886 -390 2 14.6351 9.71867 3.64602 0.226975 12.0799 18.4878 -391 1 7.91148 17.3357 9.20787 -1.7112 -7.64626 2.59046 -392 2 7.14677 17.4921 9.78359 1.89149 7.49144 -9.53339 -393 2 7.98506 17.9868 8.49476 -7.16328 0.988414 5.46347 -394 1 4.5072 14.4394 3.95775 1.71054 11.4257 7.67338 -395 2 4.60793 15.3916 4.19235 0.708777 -20.878 -0.615863 -396 2 4.75094 13.8726 4.71695 -2.09911 13.0171 -9.33913 -397 1 14.3103 7.38832 15.7657 0.217846 1.64546 9.18842 -398 2 15.2433 7.23588 15.5844 -0.0812074 1.42566 -0.574095 -399 2 14.3036 7.75428 16.6621 0.0607731 -0.988243 -5.21848 -400 1 2.8988 18.2304 1.89629 8.58281 11.0644 9.98123 -401 2 2.46496 17.5082 1.44481 -2.59003 -3.64619 -8.76243 -402 2 2.19471 18.7603 2.28641 0.940953 -0.0494932 1.95923 -403 1 7.97286 1.6093 4.54004 -3.7555 -8.8471 12.6183 -404 2 7.33734 2.04506 3.96057 8.79876 5.02214 -6.32296 -405 2 8.86006 1.965 4.43164 -2.78989 3.02833 -7.03085 -406 1 2.61876 14.1356 17.7492 -10.3822 -13.3904 -3.64852 -407 2 1.93119 13.4601 17.9363 9.46205 16.209 2.13837 -408 2 3.45643 13.7285 18.0162 -4.37303 1.24885 0.341178 -409 1 0.743255 1.70456 13.8731 3.59522 3.89384 -8.23695 -410 2 0.90651 1.38191 14.7629 -6.62821 1.47751 3.8543 -411 2 18.4338 1.82907 13.7582 5.96409 -0.15878 4.57237 -412 1 4.54424 18.6047 13.95 -3.57477 5.05027 -2.13798 -413 2 5.48468 18.3837 13.9843 -5.3566 -3.00882 -0.547935 -414 2 4.15141 18.3634 14.8001 4.77528 1.99072 0.545271 -415 1 7.0969 0.526127 18.3635 1.96349 3.45814 -4.17057 -416 2 7.27221 0.201121 17.4702 1.10961 -1.44826 4.33327 -417 2 6.13787 0.588122 18.4485 3.2238 7.1666 2.24 -418 1 16.0917 18.4266 14.1084 2.59329 0.57669 -10.3481 -419 2 15.3502 17.9157 13.7545 1.31994 6.64432 9.22997 -420 2 15.9271 18.7357 15.0116 -3.89333 -11.6647 -1.43214 -421 1 10.0733 4.52495 16.275 12.9842 -2.30982 2.85456 -422 2 11.0043 4.70153 16.4703 -2.64404 5.32532 -3.085 -423 2 10.0864 3.57376 16.1251 -6.72333 -0.470122 -1.54666 -424 1 15.8636 17.8904 4.42819 -6.03116 8.53171 5.31621 -425 2 16.3871 18.7073 4.48664 -0.23776 -8.88425 -2.03055 -426 2 14.9745 18.1441 4.72479 9.46919 -4.85854 1.60726 -427 1 6.9475 17.372 13.7315 15.8768 1.84738 17.2901 -428 2 7.36738 17.5483 14.6019 -4.78498 1.02898 -17.1267 -429 2 7.68915 17.2477 13.1142 -8.54431 1.43966 5.77183 -430 1 13.2923 6.53747 6.71701 -11.5961 -7.93952 14.6915 -431 2 14.1983 6.84596 6.64723 3.17712 4.25021 -11.0614 -432 2 12.8934 6.43009 5.84838 7.58936 1.28323 -8.80485 -433 1 7.69653 2.37351 9.2065 12.517 1.33593 -3.6252 -434 2 7.21057 2.29 10.0355 -5.39375 -0.506169 -1.44147 -435 2 7.12159 2.1318 8.46594 -3.32624 -2.43573 8.05936 -436 1 15.157 14.8759 13.6545 4.5209 -3.06988 2.24561 -437 2 15.0369 15.0852 14.5928 -3.37623 1.75424 -5.30162 -438 2 14.3708 15.1144 13.1546 1.18854 2.2818 3.55032 -439 1 9.31032 8.32311 3.71462 16.317 -0.492826 6.27183 -440 2 10.1522 8.77498 3.89843 -7.06732 -0.949504 -0.86517 -441 2 9.4815 7.39306 3.91425 -6.58464 2.05554 -3.01208 -442 1 17.7054 13.4931 16.4528 -2.79698 17.5255 -9.98682 -443 2 16.7518 13.3863 16.3682 2.15912 -8.30505 3.41837 -444 2 17.8443 14.3312 15.9805 5.97419 -5.13367 5.17943 -445 1 5.02162 10.6562 2.64136 -2.02283 -9.27068 2.47877 -446 2 5.69056 10.1772 3.15718 -2.95942 7.94984 0.663407 -447 2 4.59516 11.2797 3.2389 2.78246 -2.35968 2.10645 -448 1 3.7261 8.35111 10.2906 -2.0647 -5.12326 -12.4171 -449 2 3.87558 9.26669 10.0174 -1.23075 2.88832 6.28188 -450 2 3.61938 8.33938 11.2471 1.47542 3.72119 -0.959794 -451 1 16.077 7.09208 6.26442 0.512876 -15.8531 0.565556 -452 2 16.8498 7.55114 6.61759 -4.58181 2.74438 -1.19615 -453 2 16.2841 6.14901 6.36212 0.103861 8.35624 -6.71996 -454 1 15.1586 7.03156 9.12145 1.35056 8.00181 -20.3615 -455 2 15.9739 7.38238 9.50783 -5.19642 1.69713 -0.962803 -456 2 15.0724 7.48187 8.24992 4.14438 -5.93719 19.2407 -457 1 6.4279 13.1173 12.8809 -5.50985 -11.8139 -9.3985 -458 2 7.12916 12.5687 13.2568 1.68182 7.24531 -2.67671 -459 2 6.29661 13.8986 13.4214 -0.338885 -0.946459 7.65298 -460 1 12.1214 4.48617 13.0834 13.9874 7.50725 -12.3985 -461 2 12.203 4.65044 14.031 -7.85782 -1.77094 2.73271 -462 2 11.2673 4.11709 12.8488 -4.68474 -5.36964 10.3853 -463 1 11.3361 8.19542 7.84742 15.1179 -11.1226 16.1752 -464 2 12.0446 7.62229 7.53485 -1.89389 0.170875 -13.8157 -465 2 11.6069 8.28902 8.77112 -9.48953 8.11742 -0.143346 -466 1 17.184 10.7876 7.43369 13.5323 -0.921102 -17.174 -467 2 17.9233 10.1981 7.20811 -10.1233 -1.22821 11.3165 -468 2 17.1161 11.3267 6.63249 -5.49276 7.55364 9.36769 -469 1 5.23991 18.1348 11.0582 -10.3762 -3.21686 -5.77572 -470 2 4.63631 17.985 11.8048 7.12888 1.45886 -5.61107 -471 2 4.69408 18.0516 10.2533 5.93648 2.65605 9.16476 -472 1 7.56507 17.5919 1.8299 2.38736 9.59194 1.23507 -473 2 7.95273 16.7967 1.45285 -6.05148 -1.8022 -9.76241 -474 2 7.59068 18.2848 1.14776 -2.89899 -11.2976 1.8216 -475 1 1.88529 12.921 13.6059 -1.54804 -3.98178 5.6231 -476 2 1.43748 12.3178 14.2147 5.26513 0.934067 -3.79148 -477 2 2.14524 13.6768 14.146 -0.717118 1.88599 -5.70238 -478 1 9.71545 6.78651 14.8047 -15.2171 15.1422 7.50698 -479 2 9.90531 5.90708 15.1331 4.86835 -12.5985 -3.10865 -480 2 10.0627 6.91606 13.92 3.16992 -4.80507 -4.41639 -481 1 15.2317 4.3547 10.7806 -19.2619 -13.8042 -17.3299 -482 2 16.1692 4.17769 10.7161 9.63774 3.67614 12.8518 -483 2 15.0389 5.06132 11.3962 11.3469 5.0749 6.12787 -484 1 11.2086 6.13697 0.180528 -13.4008 -14.4307 -10.9666 -485 2 11.2654 5.18187 0.0337896 12.1183 5.06406 4.26486 -486 2 10.2799 6.29806 18.6081 2.85376 11.1709 5.84358 -487 1 0.155975 11.3317 15.1259 -12.2739 12.4049 -22.3111 -488 2 18.2869 11.6878 14.3448 9.29886 -6.35489 23.8975 -489 2 18.7388 12.0248 15.8046 -8.78344 -4.02614 -5.34871 -490 1 7.07225 9.17108 7.27057 -4.95781 3.28344 -6.42365 -491 2 6.44778 8.45946 7.46529 5.34767 -0.253084 5.87629 -492 2 7.94637 8.76128 7.25029 -3.14507 0.531691 2.27088 -493 1 18.4147 15.4309 12.3592 -5.86353 -0.606553 -5.09086 -494 2 0.72281 15.5186 12.2612 4.29187 -2.85716 2.67478 -495 2 18.0791 15.7216 11.5043 -3.32345 0.421348 1.66841 -496 1 16.5543 4.36503 5.23509 20.0373 -2.39618 26.5758 -497 2 16.7455 4.21973 6.1845 -16.121 -2.23612 -11.2684 -498 2 17.4558 4.42117 4.89188 -6.1573 5.26009 -14.9538 -499 1 17.766 3.07261 10.7271 -5.62269 10.8805 -1.85707 -500 2 0.0408353 3.2985 10.945 -3.12308 -7.03453 -2.35326 -501 2 17.719 2.23067 10.252 6.41295 1.44898 4.1666 -502 1 12.3026 0.0397215 10.1517 -5.9029 17.7484 6.25384 -503 2 11.458 0.404705 10.4688 2.82225 -9.87605 -6.68676 -504 2 12.8944 0.808865 10.1781 1.22751 -9.09827 -0.112681 -505 1 10.357 9.81077 12.3435 10.1956 0.0137966 -0.104503 -506 2 11.132 9.85287 12.9219 -4.83247 1.57396 1.64677 -507 2 10.2731 8.87192 12.148 -4.78867 -1.2901 1.32484 -508 1 0.505846 2.83821 7.01562 3.91094 -2.13436 13.3247 -509 2 0.681162 3.5182 7.67504 1.89272 4.99945 -7.1411 -510 2 0.694039 2.0503 7.53478 0.801338 -5.04329 -7.26695 -511 1 0.437103 15.2686 6.90942 10.3075 -26.8847 6.28938 -512 2 0.575652 15.2733 7.87231 -4.50905 3.86257 -7.07916 -513 2 0.764375 14.3681 6.66626 -11.1886 22.2654 -1.84191 -514 1 16.9895 7.01682 15.3107 -21.8777 2.45652 -5.46979 -515 2 17.7216 7.6089 15.1142 9.4824 -7.00642 -0.959024 -516 2 17.2645 6.09907 15.4073 14.9833 2.67634 2.96399 -517 1 9.01274 12.4171 8.12853 10.6441 15.1284 15.6095 -518 2 9.41612 11.8292 7.47716 -12.8498 -4.61215 -9.56742 -519 2 8.05003 12.5053 8.0704 6.97129 -9.84551 -10.1137 -520 1 1.26391 1.92336 3.04659 2.32337 -11.3487 -0.982019 -521 2 0.972058 2.42084 2.27545 2.43588 3.35199 3.68236 -522 2 1.90572 2.43981 3.5544 -5.46738 3.49891 -6.33947 -523 1 4.13143 15.1122 9.67174 -10.3949 2.47722 13.8895 -524 2 4.06276 15.2642 8.72313 5.39511 -1.60046 -0.0768584 -525 2 4.99495 14.7433 9.87874 3.88633 -1.07729 -6.21534 -526 1 7.19145 2.18155 14.5787 4.86443 0.520714 0.489557 -527 2 6.89453 1.81445 13.7426 1.87671 -5.23084 1.53267 -528 2 7.73681 2.92919 14.317 0.289792 2.5421 2.67041 -529 1 18.6 14.6947 2.16091 -2.26171 3.41683 0.482467 -530 2 0.820032 15.117 2.19003 5.03273 -5.31768 -1.38278 -531 2 17.9827 15.4314 2.17519 -7.65677 -2.44766 2.74205 -532 1 9.95161 2.77613 12.9401 9.45852 -1.28953 0.462065 -533 2 9.84872 2.18467 12.1812 -5.82301 1.90383 1.05008 -534 2 9.27924 3.46642 12.8986 -6.28602 -3.28272 -2.83121 -535 1 2.83159 8.92314 13.0298 -5.32883 -6.03653 -2.71455 -536 2 3.23927 9.77312 12.842 3.02047 6.8466 -0.359778 -537 2 3.51958 8.34046 13.3637 5.40811 -1.61307 4.23789 -538 1 3.22435 8.37789 3.65229 -1.03338 2.31116 19.4552 -539 2 3.68753 9.01983 3.09696 -0.346577 4.63804 7.35474 -540 2 3.38788 8.57936 4.60408 0.951973 1.27409 -22.7571 -541 1 5.6137 7.19416 8.52025 7.21613 5.80474 -6.44533 -542 2 5.78863 6.24316 8.52523 -9.99458 0.454093 3.85202 -543 2 5.0179 7.43184 9.24037 0.527922 -7.72891 3.36669 -544 1 14.8805 1.29251 2.00129 6.0675 21.6566 -5.88084 -545 2 14.8065 2.10545 2.50153 -6.7285 -1.94379 16.9269 -546 2 15.1655 1.66296 1.16284 -0.437229 -14.9075 -12.229 -547 1 8.26451 15.1933 0.836486 3.22704 -2.0235 12.9462 -548 2 8.92324 15.2163 1.54184 12.9519 -3.35665 -8.03315 -549 2 7.55879 14.6837 1.25205 -6.95241 0.364363 -7.46808 -550 1 15.625 1.34415 7.23495 -17.3283 -0.11068 -5.87671 -551 2 14.9596 0.769214 6.81661 10.6011 2.38946 3.65492 -552 2 15.1493 2.17629 7.38417 4.13791 -2.68619 2.35471 -553 1 4.93041 13.0764 18.5264 9.84655 1.48115 -2.02825 -554 2 5.35318 13.1968 0.744685 -3.49153 -1.64799 -2.34468 -555 2 5.56664 13.4414 17.8965 -2.33559 -1.35641 1.38511 -556 1 15.3557 8.48379 18.1448 0.204246 14.4785 -5.82183 -557 2 15.7265 9.09289 17.4831 -0.830936 -8.68367 1.885 -558 2 15.168 9.07051 0.245745 1.7123 -4.50429 2.39894 -559 1 12.0892 3.02993 18.3645 -15.9576 34.4498 -4.49703 -560 2 11.9769 2.60431 0.571005 13.6468 -16.1673 -1.05926 -561 2 12.5269 2.48004 17.7153 4.47893 -15.6345 5.41851 -562 1 13.2117 12.674 5.1931 -10.339 11.1011 -13.5125 -563 2 13.668 11.9204 4.80624 6.1285 -2.92776 7.79567 -564 2 13.4681 12.7869 6.11335 2.67539 -7.97004 0.458585 -565 1 6.0506 7.06933 0.0406962 1.31452 -3.72946 4.6718 -566 2 6.04306 7.98784 18.9476 0.374235 14.6189 -4.65006 -567 2 5.24553 6.71887 0.435288 -0.866845 -3.58603 0.782556 -568 1 17.739 15.9899 15.0125 -12.5206 6.16285 -12.4036 -569 2 16.945 16.5161 15.03 -7.46495 5.1976 21.0221 -570 2 17.8264 15.955 14.0627 17.7161 -15.0875 -11.5838 -571 1 13.1794 1.00208 16.5735 3.37979 -5.34722 -6.70143 -572 2 14.139 0.860857 16.6169 -5.21536 -1.33728 6.50102 -573 2 12.8035 0.137283 16.3512 2.48828 2.22182 6.02943 -574 1 11.096 14.5828 7.22348 0.0189977 4.74793 7.83345 -575 2 10.4045 14.1614 7.73717 -8.54387 -1.14011 0.371667 -576 2 11.8979 14.1335 7.50232 3.58446 -6.30574 -4.63725 -577 1 17.5104 8.62105 2.08846 14.2737 4.97696 2.51664 -578 2 16.6904 8.42754 2.54903 -5.27316 -4.4343 -3.04137 -579 2 17.6167 7.98338 1.37729 -7.36397 -7.55614 -1.26172 -580 1 12.3515 7.96855 1.99107 6.37927 0.258975 7.77687 -581 2 12.1159 8.90068 1.90258 -3.43959 -5.51169 -5.98444 -582 2 11.9581 7.4701 1.26507 -2.67829 1.90847 0.988543 -583 1 11.8954 14.6159 10.3514 1.85125 4.19108 3.73581 -584 2 12.1615 13.856 9.81631 -7.50724 5.70574 2.33101 -585 2 10.9524 14.815 10.2079 9.27078 -9.38408 -0.682121 -586 1 6.88225 7.03081 15.6002 -4.063 -7.66118 -6.77733 -587 2 7.75096 7.17076 15.1857 -5.63662 2.89282 10.0227 -588 2 6.77779 7.6167 16.36 6.70206 0.515961 -5.66863 -589 1 8.00078 4.70171 13.472 -1.59283 -4.83357 -4.64481 -590 2 7.27623 4.81783 12.8396 5.32657 -1.99722 0.885811 -591 2 8.48998 5.527 13.4768 -0.383179 2.4117 0.469228 -592 1 13.3975 12.1709 14.2706 1.21587 3.44049 5.53322 -593 2 13.2724 11.2098 14.2197 -1.68144 4.93388 -3.39254 -594 2 13.8611 12.4606 13.4725 -0.646036 -5.76058 -0.123004 -595 1 14.8166 9.4384 7.29692 -7.31149 -4.84482 -6.71483 -596 2 15.6063 9.98387 7.39943 -3.2576 1.32409 4.65546 -597 2 14.0612 9.86586 7.70853 4.31514 4.68737 1.52589 -598 1 12.6657 17.0265 3.08863 -0.499632 18.4226 10.5493 -599 2 13.0409 17.4141 3.89779 -4.03665 -9.69042 -5.1428 -600 2 12.0457 17.7132 2.78031 5.51866 -13.6109 -0.0343421 -601 1 1.16791 7.14337 17.4519 -17.3777 -0.471365 -9.17207 -602 2 0.285968 6.88879 17.7816 4.71885 8.57951 0.206219 -603 2 0.996987 7.64547 16.6337 5.09703 -7.79381 5.85561 -604 1 12.7928 5.13809 15.6672 21.9233 -6.79759 1.12632 -605 2 13.5314 4.49934 15.6812 -12.3388 3.06691 0.377185 -606 2 13.2535 5.99313 15.6546 -7.1176 -2.71451 -0.771614 -607 1 2.50804 3.40102 5.01245 -9.19737 1.42964 37.6951 -608 2 1.85734 3.08405 5.69632 14.2768 7.06331 -19.9109 -609 2 3.04485 4.07021 5.49582 -10.9118 -9.07044 -17.2872 -610 1 8.33238 11.2579 13.4651 -31.1482 13.4197 6.60268 -611 2 8.24927 11.0816 14.4232 19.8118 -8.42601 -14.5581 -612 2 9.11403 10.9307 13.0113 5.91799 -11.9552 15.0186 -613 1 12.8978 1.37199 13.3367 -3.68795 11.8567 -21.2004 -614 2 13.3586 1.33808 12.4821 5.12584 -5.42725 10.3839 -615 2 12.3812 2.18266 13.2296 0.582289 -3.8456 10.447 -616 1 6.35916 13.6786 2.13932 11.022 -2.36774 12.7417 -617 2 5.81416 14.065 2.83164 -5.92624 2.48265 -4.44044 -618 2 6.97105 13.1303 2.64934 1.90703 -2.61302 -7.4669 -619 1 15.9256 6.59608 12.7788 -4.50753 -7.00075 -5.11208 -620 2 16.441 7.14613 12.1828 -0.0403293 3.27533 -1.15613 -621 2 16.337 6.66123 13.6439 3.64448 2.92523 3.21919 -622 1 16.8436 0.710185 9.59384 -10.8386 -3.59173 0.641976 -623 2 16.678 18.424 9.8391 7.1202 6.86076 -6.23598 -624 2 16.34 0.863872 8.77611 6.63769 -2.37412 0.960785 -625 1 6.14874 11.7365 8.37914 -9.33508 -33.9533 -7.34454 -626 2 5.23473 11.5355 8.67103 13.3879 7.28881 -1.35634 -627 2 6.50048 10.8558 8.08418 -3.72877 24.3898 8.07481 -628 1 2.86629 8.64627 0.414665 29.1459 -9.93647 1.24251 -629 2 2.37091 8.1673 18.3782 -14.09 11.8062 8.4924 -630 2 2.39345 9.32329 0.907466 -18.2396 -1.77699 -9.50941 -631 1 10.1496 10.4602 6.51654 2.68196 -4.3054 1.18084 -632 2 10.6351 9.79475 7.02051 -3.21697 0.687034 0.899044 -633 2 10.5797 10.4719 5.65285 -1.94715 4.18574 1.72512 -634 1 6.74842 15.6916 6.55665 -2.66838 16.8954 6.36263 -635 2 7.13132 16.1354 7.32023 -0.325366 -7.45035 4.57015 -636 2 6.8063 16.3799 5.88394 5.31174 -8.689 -7.83261 -637 1 6.45137 13.1469 5.60457 -4.49761 -5.86725 0.527716 -638 2 6.60666 13.9979 6.03098 2.95924 -2.27328 1.19215 -639 2 5.97977 12.5923 6.23705 2.74812 2.58161 1.74453 -640 1 16.8067 12.5538 9.81832 0.32671 -4.80998 5.18546 -641 2 16.9975 11.894 9.13199 -1.38663 9.72579 -2.40586 -642 2 16.8023 13.4365 9.43343 1.83869 -5.34542 -5.01893 -643 1 6.05747 2.94525 2.83457 1.69886 0.640591 -2.15275 -644 2 6.28227 3.83854 2.57267 5.15417 9.09864 3.82618 -645 2 5.67557 2.57416 2.03485 -2.61266 -9.3622 -0.552159 -646 1 10.8942 3.30264 3.28891 6.21412 -5.01644 3.41466 -647 2 10.2824 3.98758 3.58006 -2.01501 -0.119341 -5.67488 -648 2 10.543 2.90591 2.48434 -5.60317 1.35459 0.297545 -ITEM: TIMESTEP -30 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.7097 7.05343 17.9609 20.7509 -2.32452 -4.15205 -2 2 7.78893 6.94819 18.1674 -15.0431 -3.26874 3.90688 -3 2 8.91258 6.41114 17.2706 -4.14568 0.140094 0.745653 -4 1 18.6207 8.28878 6.84456 -10.9758 14.7568 -16.4597 -5 2 0.033254 8.12327 5.87995 7.78297 -6.3031 11.7942 -6 2 0.390602 7.58629 7.343 9.14113 -10.4614 1.3502 -7 1 8.4202 18.5906 6.81681 -12.3331 6.77681 2.70587 -8 2 9.32414 0.194792 6.65918 12.4366 2.53215 -2.1327 -9 2 7.89923 0.683074 6.46691 2.1768 -2.64942 -1.08929 -10 1 6.58134 1.82408 11.6823 -18.6778 6.99539 14.5251 -11 2 5.88329 2.28495 12.2086 12.5233 -11.9933 -14.8966 -12 2 6.20729 0.949756 11.4934 -0.484037 1.974 1.03676 -13 1 7.10261 5.71907 2.36398 18.2567 -30.46 4.77574 -14 2 6.748 6.26194 3.05915 -16.1408 13.0855 0.817955 -15 2 6.89353 6.07497 1.50557 -7.56713 14.4666 -6.71064 -16 1 16.2146 10.1912 16.1045 25.8326 -16.9059 -6.28167 -17 2 17.1924 10.2614 15.9892 -26.0275 4.96146 3.01812 -18 2 15.8649 11.0425 16.3511 -1.01593 12.6392 3.03555 -19 1 10.6309 14.9782 2.32852 5.54907 12.6484 -4.66534 -20 2 10.5683 14.607 3.21596 0.623447 -1.40903 0.430751 -21 2 11.0949 15.8303 2.43151 -6.58286 -12.6372 2.6945 -22 1 17.1592 8.25618 10.4876 -10.0218 -2.97818 8.46282 -23 2 16.7485 8.99843 10.9576 2.65758 -6.15573 0.24812 -24 2 17.9939 8.575 10.1448 6.84049 6.50961 -0.847785 -25 1 14.8275 15.8902 16.3678 -10.7483 8.55828 -7.5541 -26 2 13.911 16.2262 16.382 8.40977 -5.5752 2.0788 -27 2 14.9328 15.3229 17.136 -2.68587 0.983086 7.72287 -28 1 12.1445 13.398 0.450021 7.16446 -9.51802 2.88894 -29 2 12.0254 13.4023 18.1304 -4.57533 9.09159 6.34311 -30 2 11.5749 14.0284 0.911779 -3.72154 -0.858053 -5.79964 -31 1 9.27791 5.43254 4.03115 12.5872 2.27984 -15.9713 -32 2 8.88042 5.04351 4.80522 -11.7175 -1.93285 8.71688 -33 2 8.63164 5.36398 3.31053 -0.238489 1.95718 4.1093 -34 1 1.81582 4.23406 11.6392 3.52665 -33.0533 9.77708 -35 2 1.78778 5.15359 11.8657 -3.54286 18.5189 3.84305 -36 2 2.12638 3.75505 12.4373 -4.00166 7.6753 -17.1576 -37 1 1.99877 6.82017 8.35649 4.97761 -1.46296 10.7796 -38 2 2.31944 7.23424 9.17304 -0.0326511 4.09138 -10.3959 -39 2 2.07937 5.88268 8.56766 -7.36821 -1.33929 -3.79841 -40 1 5.395 4.41162 7.94446 4.05063 -3.43427 6.53634 -41 2 5.41133 3.44966 7.94196 6.73946 -4.4132 0.768998 -42 2 4.74595 4.62804 7.28165 -7.35272 12.6119 -8.90882 -43 1 3.28409 2.93052 17.527 4.91883 3.31559 -8.51102 -44 2 3.97895 3.44036 17.0791 -2.08356 -9.03714 -1.68785 -45 2 2.70652 3.59221 17.9099 -2.28402 5.9437 7.00724 -46 1 7.47067 5.28165 6.09824 -7.47353 5.76211 -2.63966 -47 2 7.88561 6.05707 6.46631 15.843 7.70036 2.30241 -48 2 6.86027 5.05727 6.79609 -9.98425 -16.5426 3.24835 -49 1 9.77462 7.02047 11.9927 -3.16333 0.34511 -3.92757 -50 2 10.3836 6.39122 11.588 -5.90607 3.51948 -2.51732 -51 2 9.0529 7.19715 11.3548 12.4276 -3.26368 6.69514 -52 1 14.0466 3.57679 8.07144 18.6703 -0.348541 19.5758 -53 2 13.8937 4.22019 7.39343 -5.64007 13.0869 -9.16622 -54 2 14.611 4.0279 8.7381 -15.3074 -10.3909 -10.441 -55 1 4.67183 17.2138 3.98342 -17.1629 -17.7927 10.2823 -56 2 5.57476 17.4036 4.21567 13.953 12.775 -5.74716 -57 2 4.34342 17.7474 3.25626 2.59666 4.69733 -2.98879 -58 1 16.5112 16.6016 10.1232 -22.4077 14.5184 19.5552 -59 2 15.797 16.9077 10.7255 16.9762 -11.2391 -6.18282 -60 2 16.019 16.127 9.45142 2.29692 -6.2585 -6.10264 -61 1 1.96965 4.87893 0.40906 -10.7697 -8.55226 -4.93465 -62 2 2.66061 5.27529 0.941341 5.5274 3.49831 6.88318 -63 2 1.47511 5.62215 18.6951 6.32177 2.44726 -2.78863 -64 1 11.7331 13.3335 16.3023 -6.06186 -8.167 -3.78825 -65 2 11.2597 12.4992 16.3612 -10.498 -1.32756 10.0093 -66 2 12.2577 13.1697 15.5177 8.21427 7.2284 -4.69488 -67 1 10.121 11.0486 16.9167 -7.88764 10.2638 -1.90592 -68 2 10.5124 10.1783 16.9786 2.49636 -9.86729 -0.127492 -69 2 9.16626 10.9164 16.816 6.71354 -1.99355 -1.80005 -70 1 11.7161 17.4964 13.4564 0.653858 7.10726 11.4031 -71 2 12.4343 17.1488 12.9211 3.60089 1.57548 -4.57497 -72 2 11.8646 18.4589 13.5472 2.97554 -11.89 -7.13537 -73 1 6.3779 9.31416 12.2259 -8.95234 15.1635 22.3379 -74 2 6.77463 8.98312 11.4273 14.2971 -1.19702 -8.86117 -75 2 6.96666 9.97806 12.6372 -2.9053 -11.0825 -10.5803 -76 1 16.2282 12.7644 2.6938 13.255 22.6007 -2.42149 -77 2 17.0484 13.1981 2.39924 -4.54016 -10.6437 3.48813 -78 2 15.6471 13.522 2.85837 -6.5992 -7.46489 -1.32569 -79 1 0.640508 12.5852 5.88727 21.753 -1.83143 4.54161 -80 2 0.997304 12.3975 5.01963 2.04371 1.22983 -7.11515 -81 2 18.3646 12.7399 5.72186 -19.0302 3.73655 0.683884 -82 1 5.21387 16.4194 18.454 4.66732 -1.11443 8.72996 -83 2 5.89359 15.806 18.1817 0.824082 -8.56943 -13.0935 -84 2 5.59435 16.7978 0.603858 -5.48698 7.00748 3.62952 -85 1 0.548987 7.64401 4.10842 0.670348 4.32997 2.73018 -86 2 18.6015 7.92625 3.40384 -3.24873 3.72744 -1.92559 -87 2 1.36738 8.12724 3.94642 3.53853 -5.18785 -2.83474 -88 1 3.12734 8.93117 6.50347 30.4123 1.43415 3.20415 -89 2 3.68489 8.55498 7.21169 -11.4249 4.27745 -10.9708 -90 2 2.23185 8.74841 6.74202 -19.2185 -4.73256 7.28786 -91 1 7.31515 10.3274 16.2171 -7.5998 2.86538 3.08356 -92 2 6.58991 10.5191 15.6248 2.07633 0.375924 -7.53004 -93 2 6.86928 10.3012 17.0718 3.58834 -2.41696 5.50844 -94 1 11.1056 1.03439 5.00906 5.66297 2.87297 -9.25474 -95 2 11.3082 1.81468 4.47889 -2.42802 6.95123 8.17266 -96 2 10.7866 0.43271 4.33294 -5.36858 -10.0003 1.63315 -97 1 4.38851 2.75082 13.2055 -1.16421 16.6802 -23.4007 -98 2 4.78143 3.22961 13.9394 0.315345 -9.27332 13.6616 -99 2 4.20912 1.83275 13.4212 4.21877 -6.70893 11.8835 -100 1 8.39225 10.0828 1.81263 -0.204034 19.0364 -5.60934 -101 2 8.35289 10.7959 2.47026 -1.38438 -3.08289 -2.87504 -102 2 8.81547 9.35618 2.25702 3.41266 -13.1645 6.66357 -103 1 10.4926 1.73671 15.571 11.1439 -7.64614 -12.2914 -104 2 11.3949 1.40928 15.4244 -6.59208 6.73213 11.009 -105 2 10.2461 2.06593 14.699 -6.9068 1.71228 -0.826453 -106 1 2.72763 12.9186 7.78215 1.53907 -1.41162 9.17357 -107 2 3.36352 13.5565 7.43734 -3.21302 -0.65885 -4.12251 -108 2 2.22004 12.5809 7.03913 -2.76352 5.50699 -3.09439 -109 1 3.68558 11.672 5.21041 4.08504 4.36046 -3.38247 -110 2 3.45481 10.9554 5.79468 0.598863 -9.40064 6.30918 -111 2 2.92113 11.7973 4.6466 -2.33635 3.52119 -7.07475 -112 1 6.80415 14.4796 16.8864 5.34146 -11.2852 2.95693 -113 2 7.68462 14.091 16.8709 -3.70601 4.15103 0.993665 -114 2 6.49099 14.4407 15.9783 -2.62919 9.78665 -2.68056 -115 1 14.176 14.5561 3.39307 -12.5209 -3.15767 3.59597 -116 2 13.6245 15.3467 3.3085 5.15733 -4.43597 -5.06132 -117 2 13.635 13.92 3.89178 10.6994 6.10439 -0.0738324 -118 1 8.31018 18.1523 16.0453 25.0942 2.73084 1.98444 -119 2 8.89462 17.4796 16.3723 -6.95894 -25.3404 9.38217 -120 2 8.98968 0.119946 15.7574 -11.3153 21.4924 -7.69748 -121 1 4.73581 1.63729 4.92804 -12.581 -10.4736 11.5054 -122 2 3.83953 1.97889 4.8343 1.42607 1.89675 3.67103 -123 2 5.27039 2.18299 4.37483 11.2234 12.2757 -18.577 -124 1 15.0504 12.7475 16.4383 22.4341 -19.9388 -26.396 -125 2 14.708 13.1949 17.1966 -19.6268 9.49299 12.0559 -126 2 14.4413 12.6723 15.6738 0.429593 5.89098 19.3668 -127 1 15.7794 18.4162 16.8297 -23.8108 0.224717 -24.365 -128 2 16.2557 18.6157 17.6209 13.9809 -1.68 17.1984 -129 2 15.4229 17.5182 16.8969 9.44127 2.10519 2.83182 -130 1 1.1656 1.1613 16.5455 9.88565 -3.33075 -8.05438 -131 2 1.89055 1.78579 16.6066 9.02992 -0.102422 -1.61706 -132 2 0.673214 1.35844 17.3295 -13.4515 3.62078 11.8035 -133 1 18.1028 4.54571 15.8941 -4.73113 6.48399 7.96005 -134 2 18.5013 4.04336 15.196 5.27298 -10.1152 -10.2677 -135 2 18.7433 4.58481 16.606 1.22293 0.259147 -1.01212 -136 1 12.236 16.9836 16.146 14.9412 3.5391 -27.9779 -137 2 11.6416 16.3841 16.5672 -17.548 -8.54782 13.2608 -138 2 12.0887 16.8479 15.1863 -0.907912 9.23395 13.7712 -139 1 15.9498 2.53257 18.0253 10.6473 -13.6828 8.83411 -140 2 15.5627 3.24781 18.526 -5.22656 12.7326 -1.10284 -141 2 15.751 2.68965 17.0989 -3.04742 3.76351 -4.61681 -142 1 6.7038 13.8197 10.2271 2.9338 -17.2727 -3.34939 -143 2 6.61667 13.5512 11.144 -2.24755 5.72821 7.93099 -144 2 6.68776 12.9653 9.76874 -1.43812 10.35 -6.56898 -145 1 10.1318 18.2649 2.7724 -13.411 -9.16786 2.85058 -146 2 10.3828 0.244178 2.09267 2.54842 10.4954 -6.81354 -147 2 9.19143 18.056 2.59362 16.7762 1.59207 3.74676 -148 1 2.99108 17.7409 6.10283 23.0954 -1.76337 16.2177 -149 2 2.19234 17.7622 5.58671 -8.31269 -3.84851 -15.8536 -150 2 3.76803 17.7869 5.51609 -16.1123 2.00349 -4.76697 -151 1 12.5756 16.9274 7.99763 -5.18448 9.92793 0.0594024 -152 2 11.7822 16.4009 7.94219 -1.30832 -15.7704 -9.09049 -153 2 12.3073 17.5896 8.63909 10.7698 6.45321 6.22995 -154 1 14.8838 15.2691 8.24901 11.9288 7.15592 -19.4456 -155 2 14.3219 16.0313 8.11935 -17.9047 1.82161 10.6012 -156 2 15.419 15.3185 7.43747 0.964457 -9.38205 7.76842 -157 1 17.6242 18.2515 0.369787 17.475 26.3316 2.73311 -158 2 18.5101 17.9713 0.0958777 -8.0951 -12.2782 0.813683 -159 2 17.7821 0.518901 0.686034 -9.22006 -13.9572 -3.22273 -160 1 0.867554 10.3913 1.38534 13.3292 31.3771 -20.1166 -161 2 0.0708789 9.90853 1.49908 -23.2341 -17.8443 11.3974 -162 2 0.609768 11.125 0.785047 6.92113 -8.95227 10.8017 -163 1 1.63658 12.2225 3.36866 -7.99561 -17.8946 -31.9552 -164 2 1.35203 11.5128 2.74742 7.334 6.03534 21.6261 -165 2 1.63695 12.9742 2.77054 4.15295 9.67724 10.1418 -166 1 0.571199 17.2371 4.87124 -14.5407 6.59112 32.0774 -167 2 -0.059088 17.9662 4.92138 6.12201 4.50556 -13.0577 -168 2 0.445901 16.8548 5.75927 11.2459 -10.7393 -14.745 -169 1 1.10756 0.954018 9.42478 -6.01064 0.927768 -12.2971 -170 2 1.20282 0.614567 10.324 -1.80966 -3.76099 -1.37067 -171 2 0.239583 0.659806 9.09473 9.24115 0.27684 10.6776 -172 1 16.7657 2.33783 13.2856 -4.77092 -12.7415 18.4331 -173 2 16.9235 2.53629 12.3736 4.43968 6.32108 -18.3535 -174 2 16.5017 1.40258 13.3145 0.84997 6.98888 1.09187 -175 1 2.55595 15.84 12.1915 -9.99296 7.89206 -20.2214 -176 2 3.13585 15.4219 12.8083 9.49953 -6.79049 14.4751 -177 2 2.92245 15.6515 11.3148 -0.922807 -1.51117 1.32599 -178 1 16.4223 15.613 5.98575 -3.71667 -18.1819 11.7841 -179 2 17.3247 15.5921 6.33835 -0.216171 6.69275 -4.6749 -180 2 16.2529 16.4332 5.52058 8.23488 6.69239 -4.77655 -181 1 5.80627 5.05529 11.7835 2.20346 1.03406 8.57972 -182 2 5.47099 5.61389 12.5063 0.21977 1.29573 -10.4635 -183 2 5.43215 4.18052 11.9366 -3.48089 3.11082 -1.53573 -184 1 15.1897 4.8564 0.727292 -5.49239 9.65996 -2.72664 -185 2 15.2051 4.71263 1.67299 -4.1535 -7.09946 8.01526 -186 2 14.3467 5.30742 19.2217 7.5675 -5.77492 -4.69919 -187 1 16.3443 16.3423 2.09898 -10.6702 -0.501744 21.7899 -188 2 16.0343 16.7391 2.94116 7.72577 -10.997 -12.8868 -189 2 16.4832 17.1019 1.54751 7.961 8.6491 -12.4493 -190 1 0.271558 4.86315 3.80356 2.16636 -31.8967 4.70784 -191 2 0.500225 5.77685 3.71679 7.2244 19.9811 4.59738 -192 2 1.02077 4.40389 4.23265 -9.838 12.5034 -4.93629 -193 1 2.94659 15.0442 15.0679 0.642608 -6.50925 -4.27186 -194 2 2.75789 14.5701 15.8868 0.637625 5.4096 6.54553 -195 2 2.48063 15.8876 15.1248 -0.665005 -3.22304 2.52721 -196 1 1.13823 14.625 9.55769 -40.6641 2.98648 23.3687 -197 2 1.89308 14.4183 9.03602 24.2615 -17.8348 -5.78778 -198 2 0.899054 13.8694 10.146 16.149 11.9497 -18.7143 -199 1 13.6328 16.6228 11.5317 -8.77554 -4.828 10.6654 -200 2 13.2136 17.4084 11.1616 -1.58446 0.630618 -8.00902 -201 2 13.0391 15.8864 11.302 7.59245 3.60181 -7.14688 -202 1 4.70114 1.47286 0.734685 -3.14847 1.30924 1.42089 -203 2 4.10181 2.05657 0.255283 4.3012 0.912352 -3.9516 -204 2 4.12143 0.893804 1.23429 -1.01367 -7.44934 0.356301 -205 1 1.44259 18.5254 11.8725 4.87725 -20.5249 2.38925 -206 2 1.2982 0.329643 12.7089 -1.92821 4.76162 2.3937 -207 2 1.66413 17.5975 12.0994 -0.659414 17.7173 -3.45023 -208 1 11.5206 10.1171 4.06393 -3.80452 1.00663 -6.51606 -209 2 11.2843 10.553 3.23019 1.0155 -1.19537 2.23558 -210 2 12.4827 10.1039 4.08159 3.36054 1.41703 2.51077 -211 1 8.33991 12.1729 3.71569 5.40649 2.32091 -9.4304 -212 2 9.08268 12.7024 4.00206 12.7546 1.78956 -5.29094 -213 2 7.80528 12.1916 4.49536 -21.4073 -3.06625 11.8611 -214 1 14.3677 4.01314 3.28101 5.46562 4.88363 2.56432 -215 2 15.0857 4.19963 3.89805 0.543674 -3.28085 4.74869 -216 2 13.622 4.5498 3.58084 0.572713 -1.66955 -3.63784 -217 1 5.59145 1.71061 7.51389 3.0333 8.44076 -17.8773 -218 2 4.93757 1.09228 7.83941 -4.88752 -5.30351 6.58254 -219 2 5.37448 1.80426 6.56172 4.34195 -4.37145 14.4788 -220 1 17.8887 1.09435 4.8754 -0.773263 0.600717 5.02725 -221 2 18.623 1.41887 4.35928 5.70444 0.114988 -11.5441 -222 2 17.8389 1.7231 5.59879 -7.43418 -0.321368 4.00301 -223 1 6.81825 9.41317 4.48156 7.11204 -1.13267 15.9283 -224 2 6.84118 9.52277 5.44603 -5.88151 0.934362 -6.29355 -225 2 7.74851 9.26985 4.27279 -2.06614 -3.64671 -7.13223 -226 1 2.66566 14.925 1.97184 3.43761 -5.8072 22.4208 -227 2 3.31024 14.6851 2.65976 -11.6222 2.95672 -3.26291 -228 2 3.19272 14.9753 1.1906 5.92571 0.162325 -19.2981 -229 1 17.2917 12.9099 13.1468 13.6904 -32.8575 1.82925 -230 2 16.4305 13.254 13.3667 -5.78742 18.0954 -2.54799 -231 2 17.8833 13.5932 12.8229 -8.84805 15.1913 2.15275 -232 1 14.9839 10.5629 1.38454 25.7264 11.2091 10.263 -233 2 15.6084 11.2587 1.71974 -19.4135 -18.6888 -7.72567 -234 2 14.1549 11.0026 1.25075 -10.8149 6.915 -1.22185 -235 1 5.70372 6.84607 4.55662 8.80438 8.80025 -0.823305 -236 2 6.10735 7.7373 4.58073 -7.50282 -10.5851 -1.04914 -237 2 6.32636 6.24858 4.99 1.7616 -0.154003 4.43374 -238 1 8.04871 8.29405 10.2754 3.94684 3.34606 -22.4081 -239 2 8.71637 8.94856 10.0317 -1.03323 4.34225 9.84614 -240 2 7.78699 7.97842 9.39774 -4.16124 -6.72066 12.7971 -241 1 13.4913 18.3469 5.77892 -1.26098 13.9384 -13.7404 -242 2 12.815 0.368504 5.57583 1.14564 -3.93427 -2.76608 -243 2 13.0908 17.8361 6.47463 -1.65231 -11.4802 12.6171 -244 1 0.227007 2.59645 0.141675 -14.0496 12.7254 8.33212 -245 2 17.9751 2.93781 18.665 -4.73692 -13.8452 -6.2234 -246 2 0.694599 3.38298 0.431909 14.3746 0.669884 0.426623 -247 1 12.7219 11.0238 9.75183 49.8657 -12.692 14.413 -248 2 11.8223 11.0616 9.49871 -31.5247 -8.5727 -6.88909 -249 2 12.9406 10.0926 10.0008 -12.7634 16.4478 -4.29644 -250 1 0.765495 12.2256 11.092 -6.27201 -3.92882 -21.6672 -251 2 18.4439 12.3344 11.0429 5.26844 -2.50397 8.5312 -252 2 1.08097 12.384 11.9788 -3.27397 5.59862 9.72518 -253 1 5.06534 7.27352 13.4491 9.82463 3.8805 6.07585 -254 2 5.60445 7.97165 13.048 -4.44492 -2.76176 -4.56894 -255 2 5.50693 7.14172 14.2991 -3.01503 -3.24863 -0.495805 -256 1 1.24722 6.90803 11.85 29.2977 26.916 27.8288 -257 2 0.522094 7.24638 11.3513 -16.2758 4.78156 -11.2742 -258 2 1.67283 7.72942 12.2344 -11.891 -29.9717 -16.3043 -259 1 15.4903 9.51892 12.3126 7.40517 -6.095 -16.4028 -260 2 15.1231 10.4002 12.2744 -2.67202 9.46709 6.64342 -261 2 15.3464 9.12903 13.1709 -3.09066 3.82816 8.99587 -262 1 16.6298 12.8631 5.48891 1.11523 -3.92575 5.75418 -263 2 16.4995 13.8048 5.46845 -2.55881 16.2829 11.3267 -264 2 16.4805 12.6501 4.57692 -1.87933 -15.1854 -15.6508 -265 1 6.21094 9.97472 0.0957231 23.6487 -5.34392 2.82943 -266 2 5.60453 10.4038 0.703481 -3.26342 3.61778 2.3496 -267 2 7.09538 10.0231 0.521798 -18.1891 -1.30215 -0.820391 -268 1 12.348 6.08762 4.05307 2.0614 24.7942 -10.4953 -269 2 12.1492 6.85087 3.46448 11.8353 -14.4305 6.54315 -270 2 11.534 5.60454 4.05688 -13.4451 -11.2489 2.03158 -271 1 0.182227 12.8112 0.197519 7.97213 -0.157956 2.72486 -272 2 0.124577 13.5143 0.856815 -1.71897 -0.134619 0.137441 -273 2 18.3975 13.1734 18.0617 -3.09196 -0.84285 -5.0356 -274 1 3.77998 18.5905 8.57799 -18.8802 5.92516 7.26956 -275 2 3.52251 17.9827 7.88131 5.13558 -0.560148 -6.56591 -276 2 2.92387 0.359522 8.79319 10.0752 -0.462424 4.43469 -277 1 7.44275 17.2901 4.46744 -21.5086 -34.4409 7.51913 -278 2 7.83961 18.0981 4.73248 10.1677 27.4444 -0.194329 -279 2 7.33826 17.2675 3.51576 6.23588 9.30645 -6.08156 -280 1 9.24103 17.0711 12.2479 -19.3743 11.7076 -0.715804 -281 2 9.17102 16.3949 11.5719 7.91635 -8.00505 -0.934966 -282 2 10.0835 16.9964 12.6894 10.2718 -1.4174 0.528472 -283 1 13.295 12.9281 7.96455 10.8524 35.2373 8.53109 -284 2 13.4175 12.2933 8.66577 -5.31299 -13.0614 2.94334 -285 2 13.7676 13.7325 8.27776 -0.249345 -13.5851 -11.5496 -286 1 14.9473 2.96516 15.3472 -8.56764 -6.90335 7.41648 -287 2 14.4704 2.13858 15.1989 -5.86972 7.46703 2.11397 -288 2 15.5773 2.99488 14.6333 9.67131 3.29159 -8.66831 -289 1 9.8733 15.5399 16.9999 -1.15808 -3.26391 2.43146 -290 2 10.4067 14.7753 16.7398 -3.17357 -1.97936 0.56939 -291 2 9.29049 15.2638 17.7267 6.50431 4.19029 -1.43758 -292 1 11.3155 8.30103 16.5489 -8.97523 -12.184 6.64215 -293 2 10.5995 7.86385 16.0596 7.08532 7.34183 -0.412451 -294 2 11.4953 7.67267 17.2664 2.19784 9.25982 -2.90547 -295 1 3.86136 18.202 16.7472 -0.00540616 -19.6914 -20.2162 -296 2 4.27115 17.4628 17.2262 -1.12743 11.6131 4.05136 -297 2 3.85436 0.333712 17.2887 2.36829 10.2975 15.3313 -298 1 2.18996 4.14488 8.93819 0.886129 3.08448 -7.12661 -299 2 3.10445 4.02058 8.72725 13.9566 -1.85365 -12.2229 -300 2 2.19804 3.9794 9.87086 -10.6985 1.40109 20.9797 -301 1 9.87077 10.3617 9.71962 10.1113 -1.13074 11.4426 -302 2 9.57245 11.1887 9.34333 -7.01747 6.00246 -6.1834 -303 2 10.1269 10.5679 10.6319 -2.96085 -6.85282 -1.29137 -304 1 9.72151 0.827202 10.8565 -16.8019 0.79505 -1.6906 -305 2 9.17924 18.7332 11.1654 13.4836 -3.87865 6.80866 -306 2 9.14124 1.21724 10.1941 6.30814 7.82285 -3.72399 -307 1 9.21217 15.15 10.2242 6.46373 1.33184 2.55262 -308 2 8.76537 15.794 9.67699 -2.80645 8.81337 -5.09524 -309 2 8.53339 14.5081 10.4276 -6.91387 -6.36492 -2.48134 -310 1 0.979873 9.39617 10.3168 -32.1534 32.2854 2.26584 -311 2 1.01417 10.3672 10.3328 -11.1793 -7.1298 6.70775 -312 2 1.8685 9.20872 10.1515 40.6499 -19.8378 -9.87175 -313 1 16.9127 4.85919 8.18774 -4.59801 12.0977 -12.3954 -314 2 16.2737 5.53573 8.4435 0.928859 1.2732 2.05393 -315 2 16.9639 4.27263 8.93179 4.52425 -11.0836 8.47724 -316 1 14.6737 14.709 0.318185 15.3338 2.15239 -13.9805 -317 2 15.2295 14.9726 1.0606 -1.701 5.56475 -1.20644 -318 2 13.8551 14.4222 0.702232 -12.5496 -7.63291 5.74768 -319 1 3.57822 11.0521 9.58832 7.05767 -0.848593 3.86503 -320 2 3.70772 11.5491 10.4084 -2.82358 -5.49605 1.13538 -321 2 3.0796 11.6369 9.01245 -0.492053 5.16034 -4.32733 -322 1 11.1043 10.8166 1.33994 -11.5702 -13.9866 8.70354 -323 2 11.3928 11.6085 0.903197 7.06397 14.5046 -5.44138 -324 2 10.1649 10.7312 1.10986 7.36828 -2.13735 3.91294 -325 1 13.1846 7.09882 12.8318 18.6724 6.28095 -0.937746 -326 2 14.1536 6.98642 12.9472 -16.4658 1.64828 -3.93553 -327 2 12.8311 6.20921 12.7949 -4.05904 -6.33012 1.01947 -328 1 9.62724 1.89857 0.976269 -5.84048 -4.71512 -19.854 -329 2 8.85605 1.47112 0.556627 5.981 10.7585 7.84687 -330 2 10.1714 2.22507 0.238723 -1.51496 -2.73206 9.47681 -331 1 10.5937 13.5214 4.66199 3.2234 0.0339744 -7.62843 -332 2 11.4486 13.114 4.51461 3.39436 -8.72009 -0.849353 -333 2 10.7191 13.8974 5.52846 -5.55452 9.94363 9.85641 -334 1 14.3279 1.73837 10.9221 -6.80645 -20.6925 1.76137 -335 2 15.1234 1.41881 10.4767 1.97621 6.90305 1.731 -336 2 14.3743 2.69243 10.9875 9.24527 6.91542 -4.56959 -337 1 14.6348 12.3447 11.7069 0.143663 -8.85162 -7.69369 -338 2 15.3924 12.4169 11.1267 15.8185 6.23005 6.53749 -339 2 13.9779 12.0599 11.0796 -19.2308 -4.32411 1.56042 -340 1 8.24345 5.06862 9.81236 -2.43519 -19.796 -15.4196 -341 2 7.42328 5.28077 10.2334 -12.2119 11.2175 13.6651 -342 2 8.03366 4.19231 9.43495 14.0834 8.03075 2.78805 -343 1 1.55958 16.8456 18.3509 0.293915 -24.903 24.1992 -344 2 1.74487 17.2231 17.5072 8.4457 6.47265 -18.7434 -345 2 1.95964 15.9468 18.3277 -12.6492 15.8955 -3.16542 -346 1 1.46885 17.2295 15.3261 -41.9231 18.9429 7.61422 -347 2 1.60163 18.0716 15.7975 2.88525 -7.29411 -7.90761 -348 2 0.471438 17.1304 15.2829 39.2238 -5.53287 -0.382895 -349 1 3.69895 5.65007 6.13962 5.67498 -13.7905 -4.71311 -350 2 3.08621 6.15365 6.67268 -1.79156 10.6243 5.04455 -351 2 4.29662 6.26435 5.6935 -4.62364 1.91275 -0.121461 -352 1 12.3686 9.4572 14.1916 2.50325 4.1373 0.835901 -353 2 12.6534 8.64397 13.7789 7.43403 -8.19142 -7.10693 -354 2 12.2431 9.18714 15.1032 -3.68368 1.41273 6.14038 -355 1 4.03462 15.2828 6.91278 -20.0144 -6.90546 3.84648 -356 2 3.57361 16.022 6.48562 4.0204 -1.30953 4.99773 -357 2 4.97214 15.427 6.85986 17.0804 8.85667 -5.89205 -358 1 0.596937 8.57007 14.913 -2.82207 -2.34568 11.0967 -359 2 0.589839 9.51288 15.1099 0.171131 2.88226 -3.41975 -360 2 1.22453 8.45469 14.2015 6.96836 3.95738 -3.73783 -361 1 12.9772 8.31295 10.3135 -4.52981 3.4147 9.81026 -362 2 13.748 7.88649 9.95158 7.10588 -4.96512 -13.4998 -363 2 13.0418 8.05063 11.2408 -7.87478 3.04011 -0.538852 -364 1 15.3081 7.67138 3.5266 23.4653 37.2808 -10.5735 -365 2 14.5495 7.31548 3.08478 -13.5361 -20.5278 3.76808 -366 2 15.7097 7.21489 4.26906 -13.5998 -13.5183 6.32814 -367 1 17.3139 6.67347 0.0519528 8.75828 -11.5188 0.32751 -368 2 16.922 5.81479 0.236083 -1.36263 0.235584 3.31968 -369 2 16.5542 7.20912 18.4844 -8.7655 12.4237 -8.09845 -370 1 8.86065 6.91878 7.81669 10.1209 17.2302 -14.0365 -371 2 9.80786 7.17641 7.77744 -16.0922 -4.42618 4.57681 -372 2 8.74795 6.24147 8.48473 3.77983 -6.9476 8.96536 -373 1 12.3541 0.627989 1.20673 7.59332 -4.64776 2.86492 -374 2 13.2579 0.528374 1.53727 -3.51801 6.0046 2.76074 -375 2 12.2851 18.632 0.498856 -2.53947 0.382583 -4.14536 -376 1 5.64549 15.138 14.5235 -4.10456 -30.421 5.78959 -377 2 4.73353 15.1769 14.8501 2.72532 6.49481 -6.12593 -378 2 5.9656 16.0086 14.3294 1.76375 18.5631 -6.42604 -379 1 3.85619 6.49135 1.72458 1.34418 -5.76632 6.1851 -380 2 3.4082 7.28863 1.44351 -4.61345 8.91678 -8.73454 -381 2 4.04036 6.67595 2.65567 -1.04596 -4.79787 -3.17499 -382 1 3.88128 11.6181 12.3021 -8.90147 -4.54474 -0.675722 -383 2 4.76839 11.88 12.5585 3.1774 6.51538 0.922611 -384 2 3.25574 12.2257 12.7332 9.80963 -6.2977 -1.14662 -385 1 5.41097 3.86243 15.8619 7.77498 -26.7447 2.47729 -386 2 6.19051 3.2555 15.8125 -22.34 13.8462 -4.82428 -387 2 5.75732 4.74289 15.8731 9.06733 16.771 0.375084 -388 1 14.4275 10.3077 4.42737 -15.4583 -1.2468 24.8449 -389 2 14.4136 9.7945 5.25584 5.65105 6.60384 -6.24763 -390 2 14.7139 9.69599 3.76155 7.16087 -8.52398 -12.4829 -391 1 7.87022 17.3652 9.18307 -6.55512 0.129027 -0.760847 -392 2 7.04604 17.5698 9.62158 -5.94597 -4.85201 9.5143 -393 2 7.92762 18.0395 8.50377 8.60962 -1.46955 -8.60251 -394 1 4.50919 14.4633 3.94747 -3.26277 6.69504 -13.1744 -395 2 4.44326 15.3745 4.23469 1.61374 7.68172 -2.63862 -396 2 4.73121 13.9745 4.72809 3.38773 -13.7326 11.5154 -397 1 14.2916 7.39166 15.7799 -19.0102 -0.643935 -4.97281 -398 2 15.227 7.28492 15.6956 21.3172 -2.59108 -3.06 -399 2 14.1661 7.73476 16.6606 0.966931 5.43289 9.36717 -400 1 2.93597 18.2496 1.90178 2.72474 -19.4407 -7.90163 -401 2 2.41137 17.5137 1.50762 13.3283 19.165 4.04527 -402 2 2.31568 18.912 2.18531 -12.4791 7.28301 8.56329 -403 1 7.97625 1.60842 4.55987 -20.0747 11.2227 -5.58284 -404 2 7.40672 2.18903 4.02942 -3.00667 -10.939 3.58357 -405 2 8.83426 1.86357 4.26417 23.6954 -1.42515 0.234182 -406 1 2.55973 14.139 17.7235 4.4947 4.4122 -3.81652 -407 2 1.9869 13.4419 18.0532 -4.8721 0.171095 2.94118 -408 2 3.45785 13.8729 17.9629 -0.333069 -3.9381 0.822902 -409 1 0.778432 1.72633 13.8806 -27.0748 -1.51039 10.7449 -410 2 0.840363 1.33642 14.7677 3.59517 6.80992 -7.55552 -411 2 18.4512 1.86919 13.7675 25.1129 -0.50251 -4.23703 -412 1 4.5218 18.6217 13.9311 -26.2208 4.76485 6.31935 -413 2 5.44026 18.4597 14.0857 18.6112 -6.32709 -3.49173 -414 2 4.08533 18.4032 14.7706 3.39103 3.57256 -5.13956 -415 1 7.0966 0.590139 18.3583 40.0867 -7.03194 -16.485 -416 2 7.43029 0.218977 17.5038 -14.1267 7.45313 19.238 -417 2 6.15491 0.497007 18.3797 -17.6926 4.43938 -0.268226 -418 1 16.0869 18.4184 14.0665 12.1783 12.0602 19.9903 -419 2 15.2602 18.093 13.7757 -22.8702 -12.1677 -15.3509 -420 2 15.9307 18.6351 14.9998 9.22594 -1.26981 -3.76068 -421 1 10.0615 4.5254 16.2644 17.4965 34.4304 -0.599412 -422 2 10.952 4.96419 16.2693 -15.2122 -21.3498 0.578373 -423 2 10.2001 3.58581 16.3272 5.99955 -12.591 -1.94777 -424 1 15.8874 17.8488 4.44366 26.9944 -8.8935 -8.85545 -425 2 16.3583 18.6921 4.41154 0.375294 -2.3726 2.41747 -426 2 14.9936 18.0388 4.65191 -27.7242 10.9512 11.1951 -427 1 6.97313 17.3837 13.7492 -14.8371 0.980348 6.17816 -428 2 7.33935 17.5289 14.6184 6.46616 5.40365 9.01508 -429 2 7.73032 17.2786 13.1826 8.79779 -2.98362 -9.94394 -430 1 13.295 6.50203 6.69495 9.53809 17.2257 -14.0038 -431 2 14.0496 7.07319 6.46986 -0.499105 -8.31015 13.7378 -432 2 12.8724 6.42857 5.83749 -8.85952 -9.05901 -3.70628 -433 1 7.73318 2.36184 9.23357 -5.82839 -0.191385 25.6357 -434 2 7.13515 2.2598 10.0003 13.8878 3.27143 -3.38814 -435 2 7.19146 2.08044 8.50905 -8.01798 -3.82737 -18.8349 -436 1 15.1683 14.8678 13.6621 4.32457 -5.24538 6.92634 -437 2 15.0117 15.191 14.5524 1.96766 -1.10504 5.54809 -438 2 14.4461 15.1877 13.1369 -6.78809 4.58671 -11.3713 -439 1 9.33811 8.31525 3.72912 -3.71623 14.6513 -1.76526 -440 2 10.1422 8.72537 4.07444 1.32163 -4.04075 -0.39549 -441 2 9.3744 7.3721 3.88081 4.66337 -7.69389 3.46587 -442 1 17.73 13.5264 16.4473 3.62887 -10.5665 6.33517 -443 2 16.8053 13.2497 16.375 1.67263 6.91521 -3.1024 -444 2 17.8249 14.3621 15.9879 -5.28625 7.64018 -4.86126 -445 1 4.99014 10.6392 2.69296 -11.8842 10.0017 7.67541 -446 2 5.62836 10.2105 3.25699 12.1385 -6.17254 3.53336 -447 2 4.64978 11.3543 3.2597 0.304061 -9.29163 -9.90123 -448 1 3.7356 8.34279 10.2382 -0.81373 18.9096 -12.0232 -449 2 3.86658 9.26506 9.94102 0.197912 -10.4595 0.115104 -450 2 3.49052 8.44407 11.1547 0.601112 -5.92985 11.4704 -451 1 16.0428 7.05286 6.2029 -10.6575 13.2953 -5.82849 -452 2 16.855 7.48535 6.46978 4.82485 2.35526 4.73173 -453 2 16.1613 6.12013 6.32007 7.39497 -13.7867 -3.51418 -454 1 15.1327 7.05037 9.11575 3.87713 -5.32828 6.40762 -455 2 15.8626 7.43029 9.61535 2.26476 1.25298 1.00848 -456 2 15.1324 7.53151 8.29313 -1.46271 6.60183 -11.5025 -457 1 6.39444 13.0666 12.8402 5.00849 -18.9174 -4.31708 -458 2 7.14138 12.6166 13.2588 -1.3728 0.0732389 -8.28768 -459 2 6.25233 13.8543 13.3456 -7.70591 16.466 12.3405 -460 1 12.1285 4.48598 13.0882 -38.1563 -9.245 -8.92104 -461 2 12.05 4.67155 14.023 12.2106 4.08095 10.8898 -462 2 11.2367 4.10453 12.8753 29.4794 5.44987 -0.890783 -463 1 11.348 8.18475 7.8598 -17.4059 7.12531 -10.6431 -464 2 12.038 7.63484 7.48501 10.4081 -6.60064 5.31237 -465 2 11.4756 8.28116 8.80352 11.9689 -3.04214 7.26146 -466 1 17.1922 10.8074 7.44155 -25.4203 14.6985 18.6261 -467 2 17.9197 10.2075 7.32737 10.9985 -8.38668 -11.5183 -468 2 17.0629 11.3797 6.67504 9.09121 -1.65978 -2.87918 -469 1 5.25169 18.1248 11.0507 12.0648 3.50666 -3.83562 -470 2 4.62743 17.897 11.7414 -1.9785 0.423337 4.7613 -471 2 4.73712 18.33 10.2687 -7.94827 -3.02158 -5.48025 -472 1 7.57794 17.5568 1.83513 6.93874 5.3114 -35.8297 -473 2 7.86736 16.7596 1.34843 -3.99011 9.3379 11.9664 -474 2 7.57256 18.2518 1.1344 -7.92946 -12.1924 16.8763 -475 1 1.91036 12.9101 13.6013 -3.96045 -14.8375 -19.2024 -476 2 1.39392 12.2568 14.0828 0.939403 1.79227 7.54842 -477 2 2.06766 13.6568 14.1634 3.48639 14.3121 10.7878 -478 1 9.68075 6.78169 14.8149 2.18853 -17.0585 -1.56943 -479 2 9.86519 5.84438 15.0146 -5.66436 10.7434 4.7021 -480 2 10.1054 6.93436 13.9655 -4.91522 4.89205 -3.51643 -481 1 15.2489 4.31705 10.7696 10.3165 19.1063 17.7081 -482 2 16.2033 4.28261 10.8841 1.13215 -16.3849 -6.84609 -483 2 15.045 4.99149 11.4324 -10.9146 -3.35461 -8.40134 -484 1 11.2157 6.13912 0.184288 19.0347 18.6277 4.4365 -485 2 11.389 5.28379 -0.213728 -9.30505 -7.86745 -0.661886 -486 2 10.2971 6.41228 18.7766 -10.0409 -9.92482 -6.17869 -487 1 0.119384 11.3453 15.1007 -14.3711 11.1071 -8.9459 -488 2 18.1083 11.5338 14.3994 8.87914 -3.31428 2.86805 -489 2 18.675 12.1405 15.6491 -0.376992 -6.76779 4.41889 -490 1 7.06293 9.20482 7.26347 16.9728 2.93661 -2.33726 -491 2 6.45996 8.52415 7.5376 -12.746 -11.932 7.1182 -492 2 7.92776 8.76781 7.32981 -4.82181 7.51802 -3.03552 -493 1 18.3776 15.4097 12.3582 -11.3114 -7.16639 4.00893 -494 2 0.682756 15.4096 12.2525 13.0982 4.14044 -6.05458 -495 2 17.9899 15.7976 11.566 2.11158 0.973908 -1.02825 -496 1 16.5513 4.36706 5.24159 -5.09045 5.24791 -23.7034 -497 2 16.6166 4.33687 6.19466 14.1446 -5.59224 10.5876 -498 2 17.404 4.59908 4.81371 -8.86364 -4.80736 14.9956 -499 1 17.7417 3.09647 10.7341 0.291254 -10.6186 -10.4582 -500 2 0.00513181 3.34109 10.9087 8.18655 7.52385 6.55564 -501 2 17.8253 2.23203 10.2933 -8.67083 8.1401 4.47273 -502 1 12.2919 0.0227122 10.1361 2.29147 -28.3523 -7.04943 -503 2 11.4789 0.3695 10.4906 -11.5623 8.87459 2.77288 -504 2 12.9485 0.705533 10.1424 9.22066 20.6222 4.35768 -505 1 10.3653 9.79669 12.372 -8.95345 -3.20907 -9.5203 -506 2 11.0695 9.83133 13.0162 9.21286 -1.60231 7.36796 -507 2 10.2442 8.85709 12.1552 0.446892 6.98856 4.38647 -508 1 0.537603 2.83987 7.02256 -3.09155 -21.8169 -17.6677 -509 2 0.689112 3.48917 7.69969 6.81735 5.32415 12.4887 -510 2 0.745143 1.97019 7.39814 0.967775 11.9311 3.78775 -511 1 0.407687 15.2844 6.91114 -10.1505 12.0239 22.1786 -512 2 0.487576 14.9005 7.81264 0.770838 8.15944 -16.8401 -513 2 0.754028 14.6482 6.29753 4.41733 -17.9374 -4.37366 -514 1 17.0108 7.01877 15.2726 9.75856 -4.98107 -8.16179 -515 2 17.7945 7.53845 15.0774 -4.62906 13.8031 -0.900924 -516 2 17.4019 6.14594 15.3485 -8.43732 -9.20439 7.91006 -517 1 9.04118 12.4266 8.12126 20.8625 -13.8276 -21.4288 -518 2 9.31201 11.8186 7.41014 14.8696 5.22508 9.07579 -519 2 8.11227 12.3461 8.03152 -32.7632 10.2849 9.08461 -520 1 1.26557 1.8876 3.02782 9.65045 8.01813 1.36118 -521 2 0.751817 2.27104 2.32199 -7.08934 -1.28284 -8.05339 -522 2 1.78864 2.63408 3.35807 -1.4257 -10.3882 4.86199 -523 1 4.12138 15.1091 9.73113 11.5132 -2.98862 0.0844269 -524 2 4.08037 15.3711 8.80771 -6.64563 1.38763 -1.25331 -525 2 5.02377 14.7713 9.82789 -5.61093 0.302526 6.22582 -526 1 7.21558 2.18454 14.596 -3.30246 -13.7461 5.2135 -527 2 6.95017 1.78255 13.7582 4.82488 2.3919 4.06302 -528 2 7.77929 2.92256 14.3836 3.82883 9.51482 -6.38734 -529 1 18.5827 14.6796 2.1698 -24.3208 -2.36026 -2.50397 -530 2 0.827663 15.0286 2.10654 6.16868 9.29818 1.18622 -531 2 17.9285 15.4101 2.10387 15.0339 -9.50868 3.05979 -532 1 9.96457 2.76705 12.9307 -6.0306 9.60441 -0.715471 -533 2 9.81933 2.16697 12.1996 2.81266 -10.505 -5.71659 -534 2 9.23975 3.40361 12.8511 1.73763 -0.77134 6.44595 -535 1 2.86173 8.92609 13.0404 7.24036 -2.57601 -2.21085 -536 2 3.32754 9.76259 12.8684 -5.41233 -1.95407 1.34833 -537 2 3.53569 8.30272 13.3558 -0.616664 3.71534 -0.977901 -538 1 3.21505 8.40688 3.66968 15.7234 22.1036 -19.602 -539 2 3.76887 9.07341 3.20135 -16.7118 -11.852 2.14794 -540 2 3.39007 8.60458 4.57891 -0.363765 -1.98929 20.9454 -541 1 5.60252 7.19004 8.53175 5.86958 -4.86959 9.5617 -542 2 5.84506 6.27445 8.70563 -2.01066 -2.63063 -12.6146 -543 2 5.1548 7.42343 9.34691 -7.32508 9.6882 0.185442 -544 1 14.8904 1.34267 1.9851 -2.44355 -11.2972 17.4528 -545 2 14.6303 2.11535 2.51846 2.91157 0.487188 -15.3266 -546 2 15.025 1.53806 1.05778 2.17575 14.4946 -4.76666 -547 1 8.30348 15.1948 0.839181 1.62975 3.11742 -15.2912 -548 2 9.05101 15.1086 1.44328 -1.42893 -5.28711 5.64984 -549 2 7.54504 14.6965 1.17349 5.50357 -4.17517 7.24781 -550 1 15.6062 1.34647 7.22998 12.9139 6.24135 5.03718 -551 2 15.0343 0.764422 6.7383 -10.7397 -5.17 -5.22658 -552 2 15.1371 2.18077 7.35367 -5.42005 -2.19365 2.65732 -553 1 4.96367 13.0608 18.5175 -8.25637 -3.65043 -17.7207 -554 2 5.34878 13.2483 0.722802 8.16177 0.261597 12.4464 -555 2 5.65153 13.2431 17.8644 -2.22894 4.298 3.81358 -556 1 15.3614 8.50445 18.1376 -9.02232 -8.38547 12.9254 -557 2 15.7319 9.00583 17.4156 5.20151 10.9324 -8.24127 -558 2 15.1687 9.14311 0.198883 4.58141 -1.82544 -4.44514 -559 1 12.0904 3.05083 18.3558 5.74067 -18.2993 3.78166 -560 2 12.2947 2.48128 0.458355 -7.48955 9.04159 13.408 -561 2 12.4465 2.47277 17.6781 -3.43414 10.0689 -17.6065 -562 1 13.2065 12.6801 5.18634 5.84251 -1.21193 6.01102 -563 2 13.6832 11.8727 4.98831 0.374712 -2.89081 -11.6293 -564 2 13.5252 12.8732 6.07674 -9.12379 3.52213 -1.02632 -565 1 6.05538 7.10808 0.0622478 7.64822 4.54905 2.96407 -566 2 5.99209 8.01824 19.0386 -2.92171 -4.08442 -8.95141 -567 2 5.21644 6.68693 0.272307 -1.20959 2.69213 5.93171 -568 1 17.7218 15.9656 14.99 27.5308 -15.6865 18.0891 -569 2 16.9388 16.4863 15.1181 -14.3434 5.91292 -14.0866 -570 2 17.911 15.7342 14.0701 -14.8265 10.2647 -3.26624 -571 1 13.1712 0.994875 16.5867 2.52549 -1.56274 -3.32645 -572 2 14.0875 0.750433 16.7652 2.07951 0.899412 2.60052 -573 2 12.7522 0.177983 16.2988 -0.931869 -3.47373 4.92885 -574 1 11.0723 14.6005 7.26575 -13.1255 -10.0571 4.65979 -575 2 10.3507 14.0428 7.62559 10.576 8.81418 -2.61622 -576 2 11.902 14.168 7.50495 -4.44994 -4.81764 -1.49609 -577 1 17.5239 8.59779 2.09084 -4.28833 -20.5194 -15.9758 -578 2 16.6824 8.33187 2.48237 1.37862 7.81735 4.46419 -579 2 17.5834 7.99355 1.32242 5.93631 9.11716 13.4418 -580 1 12.3581 7.93946 1.97566 -1.89696 -6.27914 -3.50436 -581 2 11.9505 8.79823 2.04436 -0.86405 10.6038 1.69948 -582 2 11.9097 7.53044 1.22383 5.98844 -6.29912 5.7943 -583 1 11.9176 14.6241 10.3724 -2.87076 17.8373 18.3305 -584 2 12.1889 13.9308 9.80998 14.0474 -22.5763 -16.4958 -585 2 11.017 14.792 10.1004 -10.4734 4.60408 5.02203 -586 1 6.86179 7.0045 15.5825 0.298402 -7.5032 -11.9192 -587 2 7.72978 7.09161 15.1865 4.58892 -5.83629 -5.839 -588 2 6.8806 7.68521 16.2363 -7.39186 11.3873 16.6815 -589 1 8.0061 4.66768 13.4643 -26.1906 -20.4665 -29.1007 -590 2 7.40104 4.82554 12.6933 13.2028 -5.13213 23.0799 -591 2 8.47723 5.469 13.5831 13.4856 24.6751 2.60837 -592 1 13.392 12.1682 14.29 6.21681 3.24263 -1.56593 -593 2 13.3744 11.2127 14.1772 -7.69192 -2.80185 3.02585 -594 2 13.9051 12.489 13.5384 -1.40129 2.2659 -1.62493 -595 1 14.7806 9.45441 7.28093 -11.5532 20.7697 15.955 -596 2 15.4984 10.0862 7.4818 -3.61589 -14.7511 -6.73617 -597 2 14.0294 9.75726 7.82532 9.94729 -6.45384 -10.5104 -598 1 12.6903 16.9959 3.11063 13.9021 -20.0527 -1.11079 -599 2 13.0479 17.2495 3.95961 -1.86196 6.25123 9.18833 -600 2 12.0243 17.6278 2.88206 -13.6174 14.7021 -2.85583 -601 1 1.14933 7.13689 17.4392 -10.8552 -5.82346 1.42608 -602 2 0.254324 6.85235 17.6903 1.68989 10.0465 1.1249 -603 2 1.04814 7.64429 16.6282 0.816381 -0.80389 -4.56811 -604 1 12.8311 5.11146 15.6849 -17.6595 -4.33947 -1.38663 -605 2 13.5036 4.46543 15.459 7.94947 -3.95791 3.77703 -606 2 13.2565 5.97185 15.6774 7.16 2.75079 -1.64654 -607 1 2.47852 3.39671 5.05511 -15.8601 -20.9034 -7.20071 -608 2 1.89248 3.0773 5.76599 4.829 7.89548 -3.4806 -609 2 3.06433 4.04634 5.42706 4.34046 14.9349 7.02505 -610 1 8.31182 11.2281 13.4853 12.2486 -8.92827 -7.03776 -611 2 8.34382 10.988 14.3869 -16.2376 0.866389 37.005 -612 2 9.12412 10.7865 13.2309 -0.249665 2.67206 -26.3927 -613 1 12.9087 1.417 13.3166 0.0274524 -25.355 19.3096 -614 2 13.4801 1.21198 12.5759 3.32243 8.60198 -10.444 -615 2 12.4274 2.20637 13.1188 -4.80778 18.3372 -7.59901 -616 1 6.3961 13.6531 2.14242 21.3539 -7.72513 -19.5528 -617 2 5.86296 14.1246 2.76583 -10.9825 4.85946 19.6126 -618 2 7.0399 13.1177 2.63436 -6.77103 3.35988 1.82582 -619 1 15.9312 6.57282 12.7577 9.39393 9.94387 -6.4398 -620 2 16.4454 7.11896 12.1297 -10.141 -7.43973 7.84454 -621 2 16.2972 6.7745 13.6327 -0.398164 -4.05689 -3.4507 -622 1 16.8338 0.714138 9.59622 -4.58014 7.56344 -3.36861 -623 2 16.786 18.4184 9.78234 2.45796 -8.84878 0.088887 -624 2 16.3762 0.83732 8.75167 2.21028 0.792186 -0.559114 -625 1 6.14371 11.7069 8.36929 2.81279 3.26044 -4.5559 -626 2 5.21452 11.6136 8.62066 2.93526 -5.28935 1.80511 -627 2 6.46143 10.8412 8.07651 -3.38714 0.356066 2.25694 -628 1 2.85881 8.67012 0.388915 2.79689 11.0982 14.7719 -629 2 2.20875 8.30366 18.4701 -9.93413 -28.5632 -26.9968 -630 2 2.30006 9.32334 0.801848 8.26615 13.7996 15.8107 -631 1 10.1321 10.4555 6.53489 -7.45039 0.329373 10.0784 -632 2 10.6046 9.83719 7.10845 -0.190248 -0.487921 -4.0191 -633 2 10.6634 10.5725 5.74842 5.176 -1.34798 -7.09506 -634 1 6.75471 15.7115 6.57125 -11.9312 -6.35937 -2.57899 -635 2 7.17812 16.0056 7.37746 4.55156 8.98271 2.0062 -636 2 6.84858 16.4009 5.89838 10.4548 -3.40393 4.92981 -637 1 6.44667 13.1112 5.62964 2.65073 6.32881 3.74437 -638 2 6.67596 13.9769 6.00675 -0.0120675 -6.80172 -3.34498 -639 2 5.96115 12.6448 6.31389 0.45756 -2.92263 2.45964 -640 1 16.7937 12.5442 9.80018 5.98989 11.7335 -8.95445 -641 2 16.9887 11.9765 9.05284 -0.702856 -11.4944 -2.64553 -642 2 17.0098 13.4184 9.45025 -4.64512 -2.35242 9.41775 -643 1 6.08081 2.94855 2.81201 5.81343 6.87552 13.2918 -644 2 6.21399 3.88965 2.59312 -1.02666 -12.0092 -4.68113 -645 2 5.77459 2.45978 2.03916 -1.91968 5.61369 -5.09877 -646 1 10.8797 3.26448 3.27711 -5.41025 -2.45564 -6.20574 -647 2 10.301 3.99846 3.49319 -0.0844139 2.78359 4.78679 -648 2 10.5123 2.93026 2.45079 3.61554 -5.12824 0.569032 -ITEM: TIMESTEP -40 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.73557 7.01799 17.9607 21.964 -6.69295 -3.41675 -2 2 7.837 6.97936 18.244 -22.923 1.28376 8.03757 -3 2 8.84363 6.25859 17.3828 1.27689 0.0651665 -4.69765 -4 1 18.6647 8.30209 6.83035 -0.644058 3.99523 -48.5507 -5 2 0.211245 8.12789 5.86514 -9.60619 8.91963 25.083 -6 2 0.465598 7.58914 7.26037 9.90688 -14.2806 22.1152 -7 1 8.44495 18.6364 6.8238 -19.0399 -0.344231 6.51496 -8 2 9.34052 0.200584 6.61788 21.6732 5.78047 -4.99449 -9 2 7.92466 0.711623 6.44684 1.16681 0.183702 -1.11302 -10 1 6.56005 1.80411 11.6838 -38.7214 4.43655 14.793 -11 2 5.75321 2.272 12.0538 30.5925 -16.6996 -9.96133 -12 2 6.22943 0.898268 11.5156 6.32845 11.0599 0.0206858 -13 1 7.08366 5.68816 2.38617 22.7225 -30.9477 -12.475 -14 2 6.58152 6.21056 2.95839 -27.8787 23.1579 37.4024 -15 2 6.84697 6.04683 1.54845 0.038941 9.08719 -25.9535 -16 1 16.22 10.2137 16.0864 41.4588 -5.13522 6.23048 -17 2 17.1921 10.3703 16.208 -28.8473 -8.8876 -9.54756 -18 2 15.8271 11.0171 16.4051 -13.971 12.6367 2.51598 -19 1 10.6448 14.9575 2.33364 6.27542 19.2207 -0.856148 -20 2 10.5562 14.6084 3.22703 2.40752 -4.54155 -3.02292 -21 2 11.1101 15.8129 2.46012 -8.85901 -18.4002 -3.84051 -22 1 17.1611 8.2532 10.553 -11.2529 -0.0170881 12.6501 -23 2 16.8393 8.94572 11.1538 -1.12797 -5.57792 -5.31501 -24 2 17.9446 8.61302 10.1436 10.8511 4.56282 -2.94704 -25 1 14.7728 15.897 16.3892 -19.7826 14.9663 0.46496 -26 2 13.8411 16.2137 16.4626 21.4068 -5.53606 -7.5515 -27 2 14.9622 15.5552 17.2653 -0.403084 -10.0705 4.87845 -28 1 12.136 13.4022 0.475357 -11.3959 -2.02194 -12.751 -29 2 11.9408 13.3873 18.1673 8.9331 -2.53085 4.8524 -30 2 11.4037 13.9022 0.849725 6.62825 2.84238 11.8203 -31 1 9.29338 5.44787 4.01163 24.6694 12.616 -29.9837 -32 2 8.80858 5.1972 4.76287 -21.098 -14.9153 34.0625 -33 2 8.63435 5.49966 3.31701 -4.42724 -1.21089 -8.36553 -34 1 1.79376 4.18976 11.6282 4.46954 -46.7602 7.51249 -35 2 1.70048 5.09501 11.8512 -4.37305 32.1952 10.6933 -36 2 2.09275 3.70286 12.4334 -4.9207 12.4729 -20.4441 -37 1 2.01732 6.80615 8.34226 1.64844 10.8358 -0.647304 -38 2 2.37448 7.3471 9.0762 -2.77819 -13.6149 -8.9692 -39 2 1.92609 5.89421 8.65385 1.80745 6.26657 1.98394 -40 1 5.38901 4.42498 7.95307 14.0474 9.0477 19.097 -41 2 5.49608 3.48465 7.79451 -4.39314 -7.26091 -3.25333 -42 2 4.79389 4.80722 7.31869 -10.598 0.276841 -18.5158 -43 1 3.29732 2.94293 17.5086 17.2208 -30.0882 -17.6092 -44 2 4.02601 3.30007 16.978 -4.8938 2.423 1.99348 -45 2 2.81217 3.66256 17.8655 -12.7512 26.7583 13.4218 -46 1 7.44366 5.31542 6.10005 -2.04578 -15.3999 -38.6663 -47 2 8.07874 5.97061 6.33436 13.5587 20.8049 21.0336 -48 2 6.95124 5.08125 6.86821 -11.582 -6.53412 22.3247 -49 1 9.78574 7.01841 12.0035 -14.224 -5.31732 -23.9819 -50 2 10.3573 6.41663 11.5027 -2.93892 5.75769 9.08141 -51 2 9.02058 7.16943 11.392 19.9248 1.87014 17.2782 -52 1 14.0222 3.60384 8.07347 21.1656 -3.6634 36.3987 -53 2 13.9951 4.24089 7.37961 -2.65045 17.7741 -13.562 -54 2 14.5465 4.02482 8.8088 -19.0215 -13.1146 -21.9867 -55 1 4.60432 17.1743 3.97092 -4.17058 -8.50894 9.4345 -56 2 5.51528 17.3741 4.10719 24.7317 1.00316 8.45766 -57 2 4.31895 17.8257 3.35422 -16.1123 9.67587 -20.1592 -58 1 16.4938 16.6102 10.1803 -22.58 10.2442 28.8776 -59 2 15.6971 16.8258 10.7464 27.0105 -10.9286 -19.8859 -60 2 16.1827 15.9878 9.51957 -5.57273 -0.00226425 -4.98818 -61 1 1.9645 4.84741 0.368078 -14.0488 -12.8308 -13.2388 -62 2 2.69854 5.15593 0.879033 14.2396 9.43314 15.7095 -63 2 1.5724 5.64147 0.000503254 -0.0595591 4.00938 -5.12573 -64 1 11.6747 13.3071 16.3147 -7.05005 22.2307 18.0491 -65 2 11.0866 12.5598 16.3919 -3.1788 -17.5748 -3.92498 -66 2 12.2584 13.1709 15.5748 2.75178 -8.36686 -13.1919 -67 1 10.131 11.038 16.8986 -21.0542 26.9507 -1.58256 -68 2 10.4848 10.1706 16.8573 15.2828 -28.4038 0.505132 -69 2 9.17797 10.924 16.7712 4.48065 0.743861 -0.190366 -70 1 11.7352 17.4666 13.4614 -1.07936 25.6776 8.56908 -71 2 12.4835 17.2209 12.9203 3.02318 -9.35187 -8.63799 -72 2 11.8077 18.4454 13.5145 -0.798306 -16.7366 -1.43427 -73 1 6.39395 9.3313 12.2301 16.0138 21.1557 17.835 -74 2 6.78657 8.92292 11.474 4.59605 -10.3711 -18.9433 -75 2 7.12055 9.89522 12.5742 -21.4515 -7.31443 1.84288 -76 1 16.2436 12.8045 2.69297 9.19112 6.28957 -1.09055 -77 2 17.1119 13.1995 2.45018 -21.0084 -1.00278 4.98407 -78 2 15.5746 13.5129 2.79044 13.212 -4.74068 -2.98151 -79 1 0.66547 12.6008 5.89246 44.3801 0.278469 12.8923 -80 2 0.944588 12.4662 4.9918 4.15776 -1.70344 -11.3497 -81 2 18.3844 12.6561 5.85431 -44.3715 7.63264 -5.03051 -82 1 5.23201 16.4301 18.4413 -23.1671 11.3407 -2.74477 -83 2 5.81563 15.7669 18.0873 14.8521 -9.88299 1.40517 -84 2 5.51268 16.7513 0.656182 8.57816 -5.72834 2.04059 -85 1 0.568352 7.66823 4.13077 -28.9792 -20.0076 22.3714 -86 2 18.6051 8.03762 3.49503 -7.9612 4.34402 -11.87 -87 2 1.4037 8.01472 3.91532 39.463 15.435 -13.2826 -88 1 3.11888 8.95318 6.49662 60.4725 2.42495 -6.82714 -89 2 3.7308 8.46704 7.08062 -7.96075 9.2896 -8.18079 -90 2 2.27986 8.68504 6.76207 -50.4171 -10.8396 15.4956 -91 1 7.30368 10.3509 16.2473 20.2996 0.0228567 -17.1566 -92 2 6.66358 10.504 15.5564 -7.99994 0.888183 -0.524161 -93 2 6.82737 10.217 17.0566 -12.2765 1.21271 14.6854 -94 1 11.12 1.01485 5.00375 -0.0102216 2.84952 14.1843 -95 2 11.0857 1.87302 4.56078 2.3673 -3.0702 -4.20032 -96 2 10.7324 0.367128 4.41621 -3.73217 -2.39612 -13.1961 -97 1 4.37027 2.7904 13.2033 3.18584 17.5115 -8.99997 -98 2 4.79356 3.08499 14.0007 6.25053 15.0735 9.59097 -99 2 4.18046 1.89747 13.4272 -8.57413 -32.1756 -2.785 -100 1 8.40183 10.1302 1.81819 -11.3119 21.1596 -20.1509 -101 2 8.22596 10.8234 2.46526 3.55036 0.443395 1.34914 -102 2 8.74004 9.40086 2.30376 11.7587 -22.7948 15.5041 -103 1 10.4641 1.71908 15.5611 14.2583 -4.22402 3.33599 -104 2 11.4066 1.52258 15.371 -17.8532 5.60176 1.9802 -105 2 10.08 2.13518 14.7824 5.57904 -1.0897 -7.54918 -106 1 2.70316 12.9014 7.80195 3.19617 10.9991 1.8073 -107 2 3.3212 13.5754 7.49282 0.460726 -0.40643 1.73206 -108 2 2.13336 12.7538 7.04495 -5.07282 -6.75217 -1.11681 -109 1 3.70861 11.6625 5.14703 20.6482 18.5599 0.117703 -110 2 3.55555 10.8287 5.56068 -6.18613 -18.2271 10.4705 -111 2 3.04771 11.7826 4.47739 -15.5561 1.61657 -8.41129 -112 1 6.75631 14.4548 16.9127 8.94674 -1.78931 -0.924301 -113 2 7.71443 14.3361 16.9267 -6.94418 4.38523 0.882829 -114 2 6.52635 14.6721 16.0018 -2.96874 0.297136 0.835917 -115 1 14.1768 14.5549 3.37546 -9.20747 -5.25648 5.53536 -116 2 13.5738 15.2994 3.18581 6.88801 -12.7747 3.05988 -117 2 13.7349 13.9262 3.9882 4.46288 16.3838 -11.0193 -118 1 8.36945 18.1316 16.043 -50.6417 14.5597 -0.377943 -119 2 8.83326 17.39 16.374 32.1095 -21.5179 4.54953 -120 2 8.87194 0.178112 15.6264 24.4627 6.71878 1.23367 -121 1 4.74402 1.66109 4.92978 -19.7446 -31.5867 36.4561 -122 2 3.83516 1.95374 4.92736 -8.28526 7.01041 1.88485 -123 2 5.14187 2.10852 4.23181 25.7722 28.9669 -41.4039 -124 1 15.0327 12.6922 16.4463 -14.1895 -13.4373 -36.9651 -125 2 14.5853 13.1594 17.1179 -4.44761 17.5587 33.5367 -126 2 14.3173 12.6168 15.7704 28.0544 -5.79477 6.54775 -127 1 15.7455 18.4472 16.8494 -36.7721 -17.2537 -45.0168 -128 2 16.3082 18.5742 17.5575 42.6678 12.9246 46.9817 -129 2 15.6033 17.4929 16.845 -6.46687 1.33922 -4.84851 -130 1 1.19925 1.17644 16.5482 3.81725 -14.252 -17.647 -131 2 1.9494 1.76296 16.5282 11.9166 8.08174 5.38627 -132 2 0.720072 1.41993 17.3243 -10.8728 8.87917 17.8692 -133 1 18.1194 4.51517 15.8978 -9.12682 11.3324 16.5545 -134 2 18.3907 3.99589 15.1624 6.35448 -14.0345 -18.3092 -135 2 0.212938 4.54105 16.5062 3.72114 1.23331 1.72655 -136 1 12.2575 16.9791 16.1441 20.307 19.4582 -44.4732 -137 2 11.5756 16.5974 16.6415 -35.2707 -20.5418 23.5889 -138 2 11.9443 16.955 15.2053 9.79722 2.45701 21.3583 -139 1 15.9948 2.53341 18.0767 10.9381 -15.7258 5.9061 -140 2 15.4972 3.23449 18.4655 -6.78731 22.0319 12.1926 -141 2 15.8185 2.63494 17.1497 -1.81081 -2.22204 -19.1287 -142 1 6.71322 13.8205 10.2184 4.21251 -0.72826 -19.8354 -143 2 6.51318 13.5527 11.1172 -1.15071 -8.01371 4.0626 -144 2 6.63912 13.0526 9.6212 -3.83744 4.98216 12.3358 -145 1 10.1462 18.2988 2.74675 -22.097 -20.0437 20.6404 -146 2 10.3757 0.350258 2.15404 6.85623 19.4082 -18.4799 -147 2 9.18692 18.1396 2.61143 20.6475 -0.265938 -2.33946 -148 1 3.01179 17.7216 6.11391 16.3646 11.1083 -7.5066 -149 2 2.20644 17.7129 5.60578 -13.7656 -5.82691 -3.27397 -150 2 3.67703 17.9821 5.44947 -4.29715 -10.1951 11.4126 -151 1 12.5763 16.9057 8.00279 34.6812 6.34788 -19.799 -152 2 11.842 16.3339 7.82778 -18.535 -10.6459 7.52248 -153 2 12.4277 17.4882 8.74445 -13.6741 4.98834 7.73701 -154 1 14.8867 15.2801 8.21669 15.2681 -20.6133 -0.236719 -155 2 14.2473 15.9935 8.15265 -4.83203 2.49296 -8.82369 -156 2 15.4177 15.201 7.39136 -14.8487 16.0275 12.7595 -157 1 17.673 18.2386 0.358056 6.39969 9.72416 1.64776 -158 2 18.5627 17.8182 0.243387 -17.6184 17.4743 1.20562 -159 2 17.7074 0.56338 0.562155 11.394 -25.7036 -4.78753 -160 1 0.840605 10.4115 1.35744 37.4959 50.4012 -24.017 -161 2 0.0672579 9.99096 1.64345 -42.7842 -22.4511 10.6341 -162 2 0.58692 11.2092 0.808654 3.76922 -28.1369 19.051 -163 1 1.6843 12.2358 3.38047 -6.18426 -19.2714 -7.57792 -164 2 1.35621 11.4726 2.83119 9.65923 28.3457 4.48748 -165 2 1.68469 13.0653 2.87986 -2.69674 -10.3555 -4.68476 -166 1 0.583101 17.235 4.89274 4.80321 -10.1773 15.6529 -167 2 18.7212 18.0548 4.74777 -0.344371 -10.7938 17.6071 -168 2 0.457865 16.8228 5.79389 -3.26711 20.5272 -26.9728 -169 1 1.10197 0.931397 9.43269 -15.4399 -19.3078 -9.02275 -170 2 1.25908 0.443364 10.2575 0.781623 10.2528 -2.87546 -171 2 0.281175 0.525265 9.08113 16.3171 12.9297 7.39947 -172 1 16.7532 2.33623 13.2905 -6.48112 -9.83965 38.5991 -173 2 16.8955 2.59135 12.4052 6.16672 6.51778 -37.0535 -174 2 16.4416 1.41783 13.3009 4.47832 4.66932 -0.969858 -175 1 2.60624 15.8504 12.1681 -27.4943 19.2901 -21.9402 -176 2 3.16839 15.391 12.7532 19.3125 -15.6847 20.968 -177 2 2.92961 15.6774 11.278 4.5792 -4.36857 -3.32021 -178 1 16.4212 15.6424 6.03078 2.33398 -27.7044 12.4884 -179 2 17.3276 15.7008 6.32 9.77501 -6.8374 8.24343 -180 2 16.3266 16.4053 5.49767 -10.7497 25.3256 -21.0495 -181 1 5.80196 5.07502 11.792 -7.0375 5.38003 9.08436 -182 2 5.27256 5.62589 12.4097 12.9595 -6.51078 -10.685 -183 2 5.4277 4.18781 11.8485 -2.70068 5.27459 0.5345 -184 1 15.1729 4.86274 0.750774 -1.10571 10.9128 -33.6343 -185 2 15.2042 4.59535 1.64712 -4.27265 -9.78555 34.3171 -186 2 14.3466 5.34824 0.643665 4.19718 -3.49047 -1.12139 -187 1 16.3347 16.3636 2.07743 2.17372 -8.94604 27.567 -188 2 16.248 16.684 3.01162 -4.2135 -4.93901 -27.3972 -189 2 16.5997 17.1143 1.55727 4.53602 12.7734 -5.95158 -190 1 0.261441 4.84804 3.8055 -0.147017 -56.3045 13.8461 -191 2 0.475233 5.74211 3.84367 9.07909 56.4423 -0.745388 -192 2 0.927869 4.41838 4.37361 -9.48651 2.83213 -9.85838 -193 1 2.95802 15.0603 15.1014 -0.943114 0.172839 -27.3629 -194 2 2.80338 14.7297 15.9709 -3.98201 -9.31011 23.138 -195 2 2.36314 15.8122 15.0164 6.10514 4.60789 3.27938 -196 1 1.13815 14.652 9.54287 -29.9359 -26.3887 42.7894 -197 2 1.85794 14.2975 9.07203 33.137 -5.88851 -26.0645 -198 2 1.02375 13.9289 10.2175 -6.6715 26.0405 -18.8729 -199 1 13.5762 16.6063 11.5459 8.2131 -23.6119 0.793767 -200 2 13.33 17.296 10.9485 -9.11427 22.0857 -7.2987 -201 2 13.1805 15.8285 11.1175 -0.169415 1.89227 9.19008 -202 1 4.67714 1.46335 0.758621 16.4224 4.90719 -8.19047 -203 2 4.16601 2.0159 0.158762 -4.20381 1.9839 -0.0593356 -204 2 4.09672 0.7797 1.07984 -10.7002 -7.55851 6.47825 -205 1 1.4518 18.552 11.8572 6.2605 -28.7314 5.6203 -206 2 1.30143 0.363179 12.6934 -0.382356 1.32639 0.00372943 -207 2 1.68394 17.6168 12.0771 -1.80479 24.861 -1.36748 -208 1 11.5075 10.1198 4.02095 -18.4811 -8.70186 23.5865 -209 2 11.1917 10.5684 3.24759 -2.79925 6.67004 -19.1711 -210 2 12.4478 10.2129 4.02159 23.6747 0.339266 0.782627 -211 1 8.31226 12.1774 3.6909 13.3967 -8.0925 -50.6166 -212 2 9.08853 12.6634 3.95409 8.19758 6.83683 10.985 -213 2 7.73108 12.1161 4.40989 -25.5486 3.81511 42.2514 -214 1 14.4234 4.01167 3.27932 -6.39999 -0.808874 -15.5703 -215 2 15.0318 4.04602 4.01015 9.81333 2.6424 13.2185 -216 2 13.6949 4.61166 3.47516 -0.628596 -1.04819 4.76047 -217 1 5.60276 1.68001 7.51543 46.6974 51.3536 -38.165 -218 2 4.99884 1.09753 7.87161 -47.5789 -43.021 28.4342 -219 2 5.32972 1.80197 6.58421 6.01087 -7.11276 10.7862 -220 1 17.8847 1.08156 4.86879 -16.2479 -18.084 1.95698 -221 2 18.6198 1.37964 4.35055 14.6356 14.0949 -7.48199 -222 2 17.763 1.66674 5.61639 2.20316 6.60999 2.39214 -223 1 6.81142 9.41573 4.49306 -0.655622 0.432156 7.98772 -224 2 6.876 9.60924 5.45033 2.30801 -5.82211 -14.8304 -225 2 7.69814 9.2085 4.16641 0.21776 -0.211816 8.23149 -226 1 2.64622 14.9044 1.97705 -19.6169 -6.34757 32.4999 -227 2 3.24366 14.6749 2.7111 -2.05224 3.38495 -12.0409 -228 2 3.14951 14.9574 1.1885 18.3224 0.185563 -21.7099 -229 1 17.3026 12.9105 13.1506 5.97988 10.8617 -4.35729 -230 2 16.4943 13.3715 13.3508 -17.5214 -4.76439 4.13034 -231 2 17.8495 13.6655 12.9025 6.83053 -7.65676 -2.15198 -232 1 14.953 10.5544 1.38215 35.2581 29.1908 17.9973 -233 2 15.5812 11.2612 1.74238 -25.4064 -29.0048 -15.0024 -234 2 14.0938 10.9575 1.42777 -9.92862 1.12257 -1.65093 -235 1 5.7132 6.77849 4.57909 1.57168 19.8101 -12.7812 -236 2 6.1646 7.64962 4.62346 -11.1008 -12.4177 -0.29751 -237 2 6.30742 6.13992 4.97063 6.93571 -3.41618 11.3539 -238 1 8.02607 8.31482 10.3199 -6.67367 -6.11991 -5.1902 -239 2 8.5826 9.1064 10.2496 0.567217 -7.04018 -13.4516 -240 2 7.81744 7.96553 9.42928 8.80325 8.4252 13.4279 -241 1 13.463 18.3942 5.75922 18.2094 9.72717 -25.7917 -242 2 12.7029 0.253225 5.44631 -3.25776 3.56949 4.30859 -243 2 13.1448 17.7819 6.40042 -11.4028 -12.4364 22.7676 -244 1 0.157572 2.62906 0.18715 -8.27583 -44.4001 -2.30616 -245 2 17.9404 2.90438 -0.139246 -4.84787 10.7772 1.25282 -246 2 0.728557 3.33866 0.428035 8.4047 29.5908 2.16632 -247 1 12.7834 11.0467 9.74512 50.2143 -37.9981 33.2215 -248 2 11.9361 11.0491 9.39224 -54.8114 3.18277 -19.015 -249 2 12.8684 10.1188 10.1004 3.84712 25.3375 -10.5627 -250 1 0.745434 12.1889 11.0782 -25.5268 2.00553 -1.18025 -251 2 18.4134 12.2219 11.1204 10.6569 -0.780029 -7.62666 -252 2 1.00048 12.4147 11.9671 12.4315 1.99225 10.3147 -253 1 5.08453 7.29937 13.4403 2.24753 -3.99956 1.86213 -254 2 5.64891 7.85147 12.8757 -3.98378 2.58677 10.115 -255 2 5.52437 7.26557 14.3066 0.821915 -2.02828 -9.69703 -256 1 1.22699 6.88005 11.8698 42.6355 29.3241 27.8417 -257 2 0.513102 7.24659 11.3736 -15.3023 8.70694 -9.89945 -258 2 1.76616 7.68013 12.1994 -27.3906 -36.7234 -16.475 -259 1 15.5048 9.56381 12.3059 14.0365 -21.5239 -8.17825 -260 2 15.0446 10.3738 12.2505 -11.2614 35.3449 -7.27588 -261 2 15.2981 9.243 13.1696 0.51668 -8.53923 17.0206 -262 1 16.6213 12.8097 5.50479 11.7533 -20.9364 35.7876 -263 2 16.4281 13.7341 5.58129 -4.58024 20.9264 -6.48074 -264 2 16.496 12.5383 4.61195 -7.15835 1.38375 -28.6034 -265 1 6.25272 9.92074 0.051253 25.5558 -5.2213 19.2814 -266 2 5.65499 10.4134 0.617489 -6.63873 2.74854 -0.55683 -267 2 7.09279 9.88715 0.575545 -19.794 1.5448 -11.6918 -268 1 12.3217 6.11544 4.06855 24.0308 27.0278 -26.8963 -269 2 12.2667 6.69224 3.25542 -0.750296 -12.6773 27.7542 -270 2 11.603 5.51542 4.01585 -23.4349 -14.6267 -3.11795 -271 1 0.228308 12.8043 0.188232 11.1572 0.898125 2.61316 -272 2 0.191448 13.5221 0.829575 -7.01271 0.62324 2.49922 -273 2 18.423 13.1312 18.0517 -4.48315 2.42872 -7.20237 -274 1 3.7281 18.597 8.57641 -7.3642 13.4464 17.6561 -275 2 3.55952 18.0214 7.8301 -5.82536 1.28732 -6.71467 -276 2 2.87154 0.379366 8.79158 11.2944 -8.20129 -4.53508 -277 1 7.45075 17.3023 4.47746 -12.4687 -31.8552 -5.62811 -278 2 7.62794 18.1881 4.68695 9.53175 40.2972 16.7849 -279 2 7.50734 17.3052 3.52795 -1.99738 -6.99443 -12.8094 -280 1 9.24058 17.0897 12.2501 -24.9009 9.53262 -6.54721 -281 2 9.25026 16.4035 11.594 -4.50925 -12.7792 -11.7902 -282 2 10.1098 17.0766 12.5981 28.7243 3.47903 16.8433 -283 1 13.2876 12.9366 7.99409 13.1339 47.0026 -12.7195 -284 2 13.3658 12.2269 8.61754 6.78146 -9.97429 11.7811 -285 2 13.946 13.6564 8.215 -16.5737 -23.9385 -2.8436 -286 1 14.9278 2.97205 15.3542 -22.0243 3.95222 27.314 -287 2 14.2978 2.24466 15.255 3.92553 0.418625 -2.59085 -288 2 15.495 2.9795 14.6023 14.212 -3.72656 -21.152 -289 1 9.88733 15.5502 16.9939 -6.96656 2.06857 9.21519 -290 2 10.3024 14.7219 16.7214 3.24805 0.519307 1.1538 -291 2 9.47388 15.4159 17.8681 4.17307 -0.448199 -10.2742 -292 1 11.3272 8.33778 16.5655 -12.1447 -4.13113 3.07889 -293 2 10.5941 7.97459 16.029 11.4521 -0.447246 11.036 -294 2 11.3675 7.80686 17.3849 -1.98947 6.30133 -12.9317 -295 1 3.91087 18.2078 16.7523 8.10648 -24.8729 2.7978 -296 2 4.29329 17.4751 17.2712 -2.30537 5.45923 -13.1249 -297 2 3.83261 0.235403 17.405 -4.96911 23.3333 9.68201 -298 1 2.20524 4.16671 8.93127 -30.922 4.24465 -33.9389 -299 2 3.10409 4.18899 8.66341 29.7515 -2.18627 -0.590115 -300 2 2.16419 4.10976 9.8632 4.73941 -5.36165 36.7803 -301 1 9.8752 10.3748 9.71669 16.1383 -34.8575 15.3318 -302 2 9.43878 11.1114 9.34267 -12.9257 32.2344 -10.6144 -303 2 10.0704 10.5459 10.6459 0.567735 2.49547 1.17829 -304 1 9.70603 0.859612 10.8594 11.2219 3.05072 8.41213 -305 2 9.26848 0.0594607 11.2011 -2.07101 7.3453 -10.3505 -306 2 9.18365 1.30902 10.1791 -6.8322 -10.1071 2.86508 -307 1 9.20299 15.1273 10.2305 31.122 11.5717 5.63223 -308 2 8.76871 15.6899 9.60445 -9.85228 15.7354 -8.32779 -309 2 8.63472 14.3875 10.3233 -23.0991 -20.0884 3.25194 -310 1 0.96837 9.47951 10.2963 -70.5876 8.50765 14.6853 -311 2 0.835229 10.4182 10.5095 11.9906 -6.34251 -2.52384 -312 2 1.84768 9.33537 10.0919 56.817 -0.102153 -14.2985 -313 1 16.9556 4.85371 8.1764 15.2186 15.5475 -39.5257 -314 2 16.4324 5.61135 8.41217 -10.5813 9.18021 7.17639 -315 2 16.8473 4.22258 8.84986 -2.43363 -23.5078 29.961 -316 1 14.6968 14.7113 0.249291 21.1749 6.84176 -19.9636 -317 2 15.2416 15.0749 0.948116 1.7369 4.80193 6.96981 -318 2 13.9408 14.343 0.670519 -22.6431 -9.26918 11.3127 -319 1 3.62773 11.0513 9.55661 13.6415 -11.4582 11.5887 -320 2 3.64622 11.3868 10.4653 -1.2087 2.23818 -2.33891 -321 2 3.18854 11.7052 9.01978 -9.00441 8.94912 -6.83793 -322 1 11.1486 10.7845 1.39435 -11.9859 -27.9615 14.113 -323 2 11.4982 11.6036 1.1014 8.88176 28.2378 -14.4203 -324 2 10.2242 10.7355 1.11217 4.88573 2.00485 1.40976 -325 1 13.1617 7.12114 12.7848 27.9985 9.25187 0.204961 -326 2 14.1485 7.05909 12.8492 -22.0105 -1.86773 -1.16605 -327 2 12.8387 6.22307 12.8528 -4.13181 -6.51108 -0.646654 -328 1 9.62686 1.89618 0.979059 -11.1933 -2.25437 -17.4068 -329 2 8.86583 1.44793 0.536192 15.085 16.0595 8.12302 -330 2 10.1008 2.43338 0.313674 -4.24921 -13.4265 6.88026 -331 1 10.6169 13.5248 4.60784 -18.2432 -3.19473 -12.9411 -332 2 11.3551 12.9251 4.5569 15.1862 -3.85234 3.34493 -333 2 10.6581 13.9134 5.47279 3.49634 8.81883 14.723 -334 1 14.3649 1.74425 10.9305 5.54735 -12.1033 0.31392 -335 2 15.2006 1.47853 10.5325 -1.1471 -9.04293 -1.43649 -336 2 14.4646 2.6903 10.9924 -3.65076 12.6994 -0.169483 -337 1 14.6084 12.2765 11.688 7.48969 -0.0414248 52.7612 -338 2 15.3889 12.4412 11.1797 12.3837 0.874018 -20.9659 -339 2 13.8613 12.0797 11.1652 -22.2598 -6.69151 -32.5036 -340 1 8.22131 5.06515 9.81151 31.4859 -23.4564 -24.7693 -341 2 7.50576 5.35441 10.3398 -29.672 2.17434 15.6894 -342 2 8.09879 4.11038 9.58602 -2.47918 22.6636 6.16193 -343 1 1.53723 16.856 18.3772 -4.91865 -38.0309 19.5229 -344 2 1.81973 17.2424 17.568 8.52952 11.4507 -22.0862 -345 2 1.68062 15.8825 18.2332 -2.55663 27.9439 5.8223 -346 1 1.48989 17.248 15.3251 -39.2991 7.69546 7.77355 -347 2 1.63979 18.1273 15.7491 -10.9611 -20.0854 -9.27397 -348 2 0.505086 16.9983 15.3475 43.8724 16.6347 0.193712 -349 1 3.67894 5.68848 6.10927 6.21387 -9.44646 -9.55971 -350 2 3.15123 6.21186 6.69497 -13.0277 9.84767 14.8728 -351 2 4.18038 6.32117 5.58457 4.58642 -2.3545 -2.10993 -352 1 12.397 9.46521 14.1943 -11.4291 42.6821 2.6577 -353 2 12.6884 8.68898 13.7764 17.0449 -39.3969 -17.6043 -354 2 12.207 9.20402 15.087 -1.24705 -6.16332 16.3323 -355 1 4.0418 15.2774 6.91931 -38.8927 -2.71008 6.44315 -356 2 3.58633 16.0735 6.61178 -2.62598 -4.70343 -0.502904 -357 2 4.94439 15.4914 6.84844 41.7142 6.1892 -4.79175 -358 1 0.605801 8.58372 14.9539 0.254512 0.326548 7.88367 -359 2 0.527439 9.52499 15.1145 -2.4036 7.40824 2.35469 -360 2 1.30759 8.52231 14.3126 8.3049 -1.83762 -9.50966 -361 1 12.9717 8.29262 10.2927 -22.7594 16.3387 10.1639 -362 2 13.6731 7.84025 9.84078 14.5836 -10.6745 -2.92467 -363 2 13.0109 8.02582 11.2281 0.923047 -2.44701 -11.6389 -364 1 15.3232 7.71175 3.53457 4.84131 -0.438878 0.085747 -365 2 14.6048 7.2242 3.18847 -27.3478 1.70601 -26.568 -366 2 15.5504 7.10949 4.22607 20.3905 5.82918 25.2924 -367 1 17.3123 6.68101 0.0543458 25.2448 -11.5383 1.06581 -368 2 16.8643 5.84811 0.208139 -4.52976 -2.78536 3.6701 -369 2 16.6324 7.27442 18.4294 -24.004 18.1506 -8.07094 -370 1 8.88314 6.92259 7.79709 31.0126 27.4325 -12.7619 -371 2 9.82162 7.25311 7.83141 -27.6614 -7.83044 -3.12143 -372 2 8.85418 6.18364 8.38751 -5.1761 -15.9168 16.933 -373 1 12.3742 0.616612 1.23426 0.620177 6.71182 8.7173 -374 2 13.3152 0.448787 1.38768 -5.31542 -0.309906 -0.296651 -375 2 12.0908 0.227811 0.410291 5.35555 -3.35826 -6.33914 -376 1 5.63073 15.1419 14.5354 -14.6404 -24.282 5.65856 -377 2 4.69276 15.2374 14.754 2.80482 -4.42056 0.607876 -378 2 5.89918 16.0006 14.2671 15.2941 25.5531 -11.1631 -379 1 3.85325 6.46699 1.73385 7.01958 -17.0097 2.38606 -380 2 3.51461 7.31896 1.46783 -8.17546 12.9796 -1.79528 -381 2 4.05434 6.54403 2.67764 -3.63249 4.46552 -6.11981 -382 1 3.88854 11.6061 12.3354 -12.5844 1.40703 6.82309 -383 2 4.76337 11.9285 12.5525 8.64878 0.03141 -1.44708 -384 2 3.2838 12.173 12.8501 6.64476 -9.03704 -9.92286 -385 1 5.37483 3.86954 15.8708 7.06931 -74.8011 -5.77053 -386 2 6.14587 3.26348 15.6611 -29.2279 19.2574 6.80998 -387 2 5.70286 4.72315 15.8147 21.5682 55.4234 -2.96121 -388 1 14.3763 10.2794 4.46201 -32.4101 28.4329 49.0365 -389 2 14.443 9.83621 5.32683 0.971611 4.81404 -7.53945 -390 2 14.839 9.74155 3.87936 25.2894 -34.3452 -37.3821 -391 1 7.80918 17.3929 9.15872 22.1479 -28.1908 5.37522 -392 2 6.96403 17.5587 9.551 -17.6194 9.20761 3.63927 -393 2 7.9906 17.9725 8.42371 -6.45863 11.4679 -7.92664 -394 1 4.50911 14.4925 3.93603 -3.72296 -18.8397 -53.7951 -395 2 4.39275 15.3834 4.18687 0.185157 34.2159 14.5975 -396 2 4.6886 13.9787 4.68865 6.61933 -20.0316 37.8242 -397 1 14.2759 7.39669 15.8018 -25.3443 -8.35453 -18.4147 -398 2 15.2098 7.32722 15.7472 31.3188 -3.09541 -3.64929 -399 2 14.1076 7.77613 16.6483 -2.08075 9.82337 20.7866 -400 1 2.98131 18.2876 1.92072 -8.89863 -34.7534 -28.0783 -401 2 2.43865 17.6277 1.38436 23.5626 24.7731 19.3405 -402 2 2.37413 0.302092 2.22775 -14.7638 14.2119 8.82016 -403 1 7.98427 1.62335 4.57287 -40.8947 -0.445207 11.16 -404 2 7.39585 2.15768 4.00383 13.1095 -6.60943 2.01257 -405 2 8.85324 1.63658 4.22836 26.1363 6.2526 -15.7033 -406 1 2.50726 14.1431 17.6951 16.6159 21.4268 -10.1577 -407 2 1.94925 13.5738 18.1946 -18.2656 -19.6261 9.9334 -408 2 3.40865 13.8863 17.9244 2.82527 -4.33175 1.96247 -409 1 0.811695 1.74837 13.8925 -21.7292 3.59652 4.70406 -410 2 0.795118 1.42008 14.8166 -3.87613 7.88135 -16.9479 -411 2 18.5211 1.96459 13.6307 25.6616 -9.0685 11.0917 -412 1 4.4852 18.6484 13.9168 -33.7534 10.3053 3.09674 -413 2 5.3921 18.406 13.9761 25.2496 -8.78408 2.09715 -414 2 4.08373 18.5038 14.7912 8.14506 -1.30426 -6.00867 -415 1 7.12802 0.652367 18.3595 35.0739 -19.2419 -26.0317 -416 2 7.40845 0.19154 17.5185 -9.63956 16.0629 26.4358 -417 2 6.18456 0.683953 18.3433 -21.3742 6.93569 3.25827 -418 1 16.0657 18.4123 14.0301 53.2891 7.60066 12.7833 -419 2 15.2177 18.2242 13.7261 -48.7282 -11.4797 -7.69178 -420 2 16.0808 18.482 14.9966 -9.66087 4.27341 -2.7923 -421 1 10.0672 4.54369 16.2573 46.2132 32.473 -7.3661 -422 2 10.9795 4.93172 16.0704 -30.9355 -10.7562 9.7222 -423 2 10.2805 3.63455 16.4071 -7.05314 -22.7581 -0.39686 -424 1 15.904 17.802 4.45553 44.7656 -19.4466 -14.3322 -425 2 16.4088 -0.0282793 4.41597 5.24747 5.32524 1.83839 -426 2 15.0633 18.045 4.74212 -51.1512 14.4852 15.4733 -427 1 6.99737 17.3998 13.7879 -47.9218 -2.31875 -13.0268 -428 2 7.40243 17.6398 14.5891 19.7576 8.98543 35.5766 -429 2 7.70074 17.2583 13.1843 23.2619 -4.97282 -20.0499 -430 1 13.2941 6.48376 6.64986 8.60711 15.0683 16.7306 -431 2 13.9993 7.1541 6.49159 -11.9149 -19.7057 -4.80273 -432 2 12.8211 6.29295 5.83939 3.46216 6.87198 -11.4398 -433 1 7.76205 2.3443 9.26472 15.7579 10.991 45.3998 -434 2 7.20759 2.25447 10.0765 8.01487 -1.94761 -18.5756 -435 2 7.26048 2.06297 8.52639 -23.6607 -10.4133 -22.8687 -436 1 15.1706 14.8583 13.6757 15.7984 -16.1031 1.44613 -437 2 15.0167 15.231 14.5413 -6.09806 3.71972 9.46304 -438 2 14.6225 15.2955 13.0407 -11.5903 11.1836 -9.13521 -439 1 9.36431 8.31687 3.74781 -9.55399 11.9025 -3.42765 -440 2 10.1518 8.60925 4.20014 9.2003 9.72282 -0.0746101 -441 2 9.3553 7.37835 3.87681 -0.285781 -17.995 1.20514 -442 1 17.7597 13.5616 16.4405 -12.156 -24.6438 9.82021 -443 2 16.8551 13.2283 16.3395 1.48334 1.58847 4.06975 -444 2 17.7289 14.3961 16.0037 5.37456 23.0458 -12.1714 -445 1 4.95841 10.6088 2.75519 -22.9294 18.7883 -14.1686 -446 2 5.66909 10.277 3.27928 16.3083 -8.75526 16.0734 -447 2 4.6114 11.3873 3.23357 6.81328 -15.8641 -4.024 -448 1 3.73362 8.35206 10.1813 3.02598 13.3252 -21.6654 -449 2 3.8939 9.27056 9.86724 -4.6548 -13.2191 9.23973 -450 2 3.49789 8.39898 11.1021 -0.178845 4.23779 13.7606 -451 1 16.0042 7.01418 6.13738 -12.6879 19.8807 -2.17242 -452 2 16.808 7.4479 6.40937 10.6213 6.47779 2.98579 -453 2 16.2019 6.09716 6.06821 5.44302 -25.895 -2.3467 -454 1 15.1221 7.07483 9.10103 -4.15707 -25.1338 32.4641 -455 2 15.7464 7.4872 9.69859 9.03801 3.43378 3.13104 -456 2 15.1481 7.58948 8.33098 1.37226 23.8896 -40.0507 -457 1 6.35284 13.0135 12.8052 -0.193314 -18.9728 -17.7547 -458 2 7.21044 12.6571 13.0708 -4.00291 0.344811 4.20755 -459 2 6.11805 13.741 13.3614 0.492624 18.505 17.8288 -460 1 12.1195 4.49733 13.0969 -26.0004 -21.5883 -29.3264 -461 2 12.1632 4.68913 14.0325 -4.53328 -3.39715 11.6105 -462 2 11.3073 3.93318 12.8667 31.5163 26.387 18.3053 -463 1 11.3554 8.17046 7.8728 -3.27026 2.45633 -4.65198 -464 2 12.0683 7.62612 7.54639 6.23155 -9.6048 -12.5756 -465 2 11.5676 8.24955 8.79484 1.17104 5.44951 18.1694 -466 1 17.1791 10.8374 7.47157 -22.685 17.097 10.0101 -467 2 17.8401 10.2117 7.26521 25.6893 -28.4186 -0.815308 -468 2 17.2004 11.4333 6.72646 -9.08817 8.64759 -4.95169 -469 1 5.26928 18.1244 11.0251 26.2987 0.0330793 2.18763 -470 2 4.69547 17.8637 11.7317 -9.61751 -4.26247 14.7568 -471 2 4.70076 18.4264 10.3375 -16.9 2.57743 -21.8459 -472 1 7.59635 17.5306 1.81531 -10.9531 4.1869 -25.2725 -473 2 7.77056 16.6988 1.31883 2.24077 21.8764 10.5056 -474 2 7.30155 18.2046 1.15131 11.3055 -17.5184 13.1347 -475 1 1.92843 12.8944 13.5862 -6.59595 -16.5477 -16.8116 -476 2 1.43666 12.2821 14.1316 -5.58333 -5.88714 5.06202 -477 2 2.04362 13.6601 14.1181 9.10211 24.5058 14.6097 -478 1 9.63922 6.76943 14.8194 -3.94612 -18.0692 3.52162 -479 2 9.76751 5.80583 15.0218 -0.27339 26.7602 -8.06829 -480 2 9.98245 6.98264 13.9392 -2.96138 -9.43899 0.82382 -481 1 15.2804 4.29771 10.7711 -7.29951 -1.41697 -0.334277 -482 2 16.1821 4.02615 11.0218 -9.71269 11.8498 1.69675 -483 2 14.9105 4.9568 11.3864 17.8049 -7.45406 -3.59162 -484 1 11.2365 6.16159 0.180514 3.71779 6.92115 0.875598 -485 2 11.3264 5.36714 18.3195 14.2335 -18.3801 -6.22284 -486 2 10.2946 6.26806 0.197414 -17.1549 12.9032 2.71424 -487 1 0.0669242 11.3685 15.0652 13.212 -6.85086 18.3683 -488 2 18.0421 11.4114 14.3938 -11.7915 7.94746 -16.0964 -489 2 -0.126536 12.1197 15.6445 1.80559 0.362507 -3.06694 -490 1 7.04679 9.22841 7.26069 23.2883 20.8536 -5.26127 -491 2 6.49897 8.58869 7.67863 -15.4435 -25.8158 9.46312 -492 2 7.95399 8.89143 7.34084 -8.97527 1.37154 -2.4384 -493 1 18.3457 15.377 12.3544 -10.4554 -0.385944 -2.00928 -494 2 0.632165 15.4053 12.1583 18.2501 2.20759 0.366712 -495 2 17.9344 15.8751 11.6412 -4.56296 -0.981709 -1.73702 -496 1 16.5292 4.37759 5.24858 18.1125 19.5767 -27.8403 -497 2 16.7661 4.20984 6.14013 0.307987 -10.9951 33.7785 -498 2 17.3779 4.70209 4.86684 -19.0742 -11.8317 -4.1687 -499 1 17.7267 3.12899 10.7335 -24.2941 -12.2101 -5.28174 -500 2 18.5902 3.43151 10.9823 20.7538 0.196381 3.18907 -501 2 17.7917 2.2294 10.3565 4.74658 11.2046 4.02468 -502 1 12.2912 0.000462328 10.1205 5.29277 -42.3116 -12.7781 -503 2 11.463 0.345322 10.3908 -30.9755 9.64408 8.62664 -504 2 12.8898 0.704281 10.2182 28.9402 34.0259 3.93413 -505 1 10.3772 9.78855 12.3993 -21.9688 -12.411 -17.7787 -506 2 11.0129 9.78765 13.1014 16.013 1.76066 13.7043 -507 2 10.1738 8.8461 12.2399 4.72709 11.7982 0.616329 -508 1 0.569471 2.8284 7.02034 6.04311 -30.2491 -2.51113 -509 2 0.820763 3.41522 7.71636 2.48105 19.4463 13.5049 -510 2 0.862153 1.97327 7.38155 -6.15059 8.48947 -7.95665 -511 1 0.371359 15.3036 6.90441 -15.8595 21.8666 50.0789 -512 2 0.449232 14.6844 7.65301 -0.190166 17.9034 -2.10351 -513 2 0.621967 14.7945 6.18679 16.5003 -37.2512 -48.0182 -514 1 17.0414 7.00877 15.2159 -22.6634 4.89001 -1.64325 -515 2 17.7376 7.6544 15.0563 8.01654 -6.9456 2.15019 -516 2 17.4056 6.16817 15.5101 9.28872 0.897926 -1.45041 -517 1 9.06316 12.4266 8.08985 69.8766 6.47542 -0.0200154 -518 2 9.44101 11.8026 7.43298 -17.7999 4.13897 6.91255 -519 2 8.14431 12.4062 8.1331 -54.6706 -8.19385 -9.80298 -520 1 1.26891 1.85581 2.9921 11.7044 -8.67905 12.4997 -521 2 0.561231 2.0509 2.38915 -6.84046 11.4219 -12.1453 -522 2 1.65109 2.68456 3.32008 -5.2596 -5.54909 -2.36563 -523 1 4.11753 15.1048 9.79523 4.78264 -4.87511 12.6416 -524 2 3.99332 15.4569 8.91057 5.07926 -2.88804 -4.85995 -525 2 5.03278 14.7822 9.88586 -9.66079 5.58119 -5.37355 -526 1 7.25278 2.18203 14.6254 -0.555581 -14.0599 -5.06396 -527 2 7.1005 1.71681 13.7878 -2.90711 2.6098 7.34806 -528 2 7.71992 2.97108 14.3713 4.55177 12.8631 -2.10328 -529 1 18.557 14.6494 2.1729 -24.7771 22.3853 -4.36836 -530 2 0.778963 15.0461 2.09778 12.8139 1.02797 3.11036 -531 2 17.9275 15.4159 2.12338 10.4684 -24.8222 2.25012 -532 1 9.97282 2.76121 12.909 0.960373 12.9666 17.7509 -533 2 9.84581 2.0662 12.2717 -5.76657 -8.74665 -14.3806 -534 2 9.17654 3.31629 12.9308 6.08178 -3.78367 -5.74316 -535 1 2.89833 8.91803 13.044 14.9503 3.68581 0.826535 -536 2 3.29774 9.80788 12.9186 -7.17545 -13.4779 0.185991 -537 2 3.62224 8.34145 13.3619 -7.75262 8.46695 -4.72395 -538 1 3.21711 8.45664 3.69888 -1.45646 11.2765 -73.7917 -539 2 3.66926 9.20612 3.219 -10.9411 -20.3742 19.6072 -540 2 3.34915 8.55803 4.60102 11.7629 13.1896 57.1484 -541 1 5.60205 7.18882 8.56127 11.7766 6.17403 -13.6051 -542 2 5.73377 6.23122 8.60856 -5.21401 3.91262 5.39773 -543 2 5.15686 7.50265 9.34977 -6.87961 -7.75657 6.1504 -544 1 14.8989 1.38427 1.96946 -15.0866 25.6457 3.84218 -545 2 14.4906 2.19786 2.32837 7.96598 -16.9425 9.74227 -546 2 14.9786 1.62425 1.05302 13.5137 -6.97514 -15.0219 -547 1 8.3539 15.1902 0.828571 -0.607384 -15.7884 -3.69873 -548 2 9.11456 14.9295 1.35098 9.06641 9.90213 6.9538 -549 2 7.64957 14.6447 1.20074 -5.27592 0.575252 -4.39528 -550 1 15.5904 1.35118 7.21966 19.131 18.1941 14.0102 -551 2 15.0458 0.788774 6.70847 -19.486 -21.9805 -16.5491 -552 2 15.0172 2.08736 7.44992 -1.58717 6.06663 4.11757 -553 1 4.99095 13.0428 18.5017 -11.814 -5.03203 -22.7016 -554 2 5.38558 13.1981 0.699871 9.67176 2.40993 22.9792 -555 2 5.69857 13.2122 17.8695 -3.662 3.61759 -0.881885 -556 1 15.3616 8.52427 18.1264 -8.5134 -8.81723 23.808 -557 2 15.7284 8.98559 17.3934 10.1937 15.818 -24.0842 -558 2 15.2728 9.20414 0.16849 -1.83009 -5.75583 -0.912989 -559 1 12.0932 3.04939 18.3516 -14.5656 24.4873 8.42937 -560 2 12.4759 2.51827 0.417994 -2.38649 -9.33387 -9.98316 -561 2 12.2916 2.69447 17.4847 9.72648 -15.0074 2.48816 -562 1 13.2068 12.6815 5.17314 -7.19784 6.47098 -0.665029 -563 2 13.7108 11.8878 4.96601 4.53767 0.295949 3.70661 -564 2 13.3847 12.9363 6.09127 2.00425 -11.4311 -4.02895 -565 1 6.06883 7.14745 0.0914664 -7.81354 22.5487 2.98517 -566 2 5.88319 8.11419 0.19427 8.4279 -22.2037 -4.79949 -567 2 5.22519 6.72532 0.292473 3.10856 -0.243494 3.48057 -568 1 17.7194 15.9325 14.9871 -5.54638 -4.40987 -28.7902 -569 2 16.9069 16.4169 14.9498 -12.3977 10.2544 17.1316 -570 2 17.7594 15.7087 14.0393 19.0068 -3.79668 12.8095 -571 1 13.1727 0.977833 16.5926 -11.6444 6.00991 -1.45652 -572 2 14.0026 0.708875 16.9779 14.0624 -0.886732 -0.671765 -573 2 12.7076 0.152182 16.4397 -1.15444 -5.20647 -2.10321 -574 1 11.0384 14.6069 7.3103 -17.4066 -34.6271 2.52502 -575 2 10.2783 14.0261 7.58336 17.6612 20.778 -3.294 -576 2 11.8174 14.0391 7.44317 -4.14385 7.222 1.39489 -577 1 17.5379 8.55913 2.08836 4.35413 -11.6997 -13.5411 -578 2 16.664 8.39738 2.48219 7.20941 -2.48593 -6.20174 -579 2 17.6519 7.91106 1.34391 -7.20398 14.5397 25.454 -580 1 12.3635 7.91649 1.96817 14.6342 -23.934 -0.413214 -581 2 11.8532 8.69875 2.12901 -10.659 13.0689 -1.52352 -582 2 11.9409 7.3888 1.27378 0.548374 7.65925 3.61612 -583 1 11.9419 14.6308 10.3966 13.4402 32.5881 48.4479 -584 2 12.2905 14.0069 9.8182 12.9115 -34.2012 -37.3181 -585 2 11.0351 14.785 10.1903 -23.9611 0.860738 -9.13817 -586 1 6.84298 6.98317 15.5594 -28.1276 -29.1686 -18.0428 -587 2 7.705 6.91496 15.176 20.6419 5.27277 -3.3528 -588 2 6.85291 7.68491 16.1747 6.25697 23.8787 22.837 -589 1 8.01998 4.63032 13.4448 -35.0292 -26.7707 -36.5428 -590 2 7.42844 4.80515 12.6548 14.5268 -5.56395 32.2217 -591 2 8.43798 5.44118 13.6312 16.8653 30.885 3.99265 -592 1 13.3984 12.173 14.3104 -3.57217 10.7678 8.64565 -593 2 13.233 11.2355 14.1881 -1.19303 -4.98427 -3.70246 -594 2 13.8945 12.4998 13.5522 0.86121 -3.67781 -4.0367 -595 1 14.7231 9.47939 7.26845 -4.38272 9.59825 17.375 -596 2 15.5232 10.0108 7.49545 -18.3981 -9.5314 -3.88615 -597 2 14.0057 9.68134 7.91225 20.1628 1.06432 -13.939 -598 1 12.7179 16.9622 3.14627 23.4566 -37.2939 -10.6207 -599 2 12.9355 17.1415 4.04114 9.03221 7.6908 26.6047 -600 2 12.0213 17.5358 2.94483 -34.3001 33.1559 -14.5415 -601 1 1.10947 7.12267 17.419 -6.10821 -8.12856 16.9857 -602 2 0.178422 7.136 17.6887 4.23762 -2.5375 0.360706 -603 2 1.14096 7.54201 16.5672 -1.29203 8.00191 -14.7545 -604 1 12.8573 5.07319 15.6916 -26.4132 -0.426227 -0.347566 -605 2 13.5067 4.42508 15.4662 18.5417 -18.6841 0.103563 -606 2 13.3354 5.89586 15.6754 6.08426 15.3432 1.29959 -607 1 2.44451 3.37888 5.09109 -12.3042 -30.7639 -30.2825 -608 2 1.89914 3.20439 5.84354 -15.8924 -6.60657 16.2411 -609 2 2.9157 4.14854 5.30475 25.2943 38.046 11.4255 -610 1 8.30318 11.1757 13.537 -17.7368 31.3122 -83.5918 -611 2 8.23756 10.9827 14.4193 9.23305 -26.2584 72.471 -612 2 8.98641 10.7011 13.0548 11.9243 -7.18625 13.6047 -613 1 12.9121 1.44799 13.2982 3.17544 -30.959 19.595 -614 2 13.5829 1.31511 12.6431 13.7174 -5.57278 -14.8203 -615 2 12.5671 2.27513 13.0597 -18.9903 37.7092 -4.23536 -616 1 6.45025 13.6395 2.14169 21.7214 -12.6454 -10.4453 -617 2 5.88722 14.0323 2.78408 -20.3944 14.637 16.9787 -618 2 7.03563 13.0797 2.67163 0.317992 1.20831 -5.89746 -619 1 15.9341 6.54969 12.734 7.51439 18.2634 -8.82177 -620 2 16.366 7.12442 12.0552 -8.93517 -14.9663 18.1444 -621 2 16.3202 6.79095 13.5987 -1.79943 -6.04596 -11.4359 -622 1 16.8134 0.715269 9.59469 1.51011 24.5111 -1.75686 -623 2 16.9773 18.4324 9.6759 -2.99022 -25.9416 6.21625 -624 2 16.4855 0.841275 8.69831 -5.26956 1.43879 -3.58435 -625 1 6.14183 11.6821 8.34851 2.12045 33.7206 2.80541 -626 2 5.25373 11.5769 8.68031 -11.2997 -2.21294 6.8592 -627 2 6.41363 10.8186 8.10997 12.8023 -29.2169 -10.6172 -628 1 2.82878 8.69633 0.366162 65.7357 7.98524 25.914 -629 2 2.25196 8.1872 18.4995 -43.1364 -19.0897 -25.1642 -630 2 2.39827 9.3921 0.850531 -20.8372 5.7472 0.329713 -631 1 10.1125 10.4546 6.55694 -3.88563 -4.31924 12.8938 -632 2 10.5628 9.81084 7.11921 -1.26662 -0.776779 -0.718706 -633 2 10.7076 10.6109 5.83303 6.58413 -0.38446 -16.1853 -634 1 6.75197 15.7318 6.59922 10.1749 2.21511 -7.15796 -635 2 7.21229 16.0038 7.38721 0.121014 2.00215 12.9298 -636 2 7.17446 16.2736 5.9175 -9.12202 -3.23328 -2.5626 -637 1 6.44006 13.071 5.66115 9.01876 9.03356 -0.68679 -638 2 6.7952 13.9213 5.9766 -6.67057 -7.15315 -1.80184 -639 2 6.02558 12.6573 6.41982 -1.29087 -3.79345 3.79648 -640 1 16.7894 12.5351 9.7661 -6.01106 14.3853 23.3751 -641 2 16.9466 11.9627 9.02496 7.22561 -5.83165 -16.8213 -642 2 17.1452 13.4178 9.59292 -0.312151 -9.66884 -5.48162 -643 1 6.11103 2.94777 2.80745 -0.0522908 21.1759 -16.381 -644 2 6.20729 3.87808 2.49328 4.01665 -19.1858 15.5438 -645 2 5.82625 2.47942 2.01203 -2.73031 -5.31149 4.59086 -646 1 10.8562 3.22295 3.2592 5.83487 -6.01133 1.10343 -647 2 10.3184 3.99141 3.45824 -8.06424 0.347936 -1.44444 -648 2 10.5285 2.8344 2.43843 -2.26863 2.18612 2.83427 -ITEM: TIMESTEP -50 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.76267 6.9614 17.9655 18.039 1.32171 0.971735 -2 2 7.88851 7.04905 18.3237 -17.7355 -1.2272 4.07533 -3 2 8.77103 6.18416 17.4071 -1.73171 -4.43635 -4.46665 -4 1 18.7148 8.30367 6.79977 -11.0979 19.7573 -45.8218 -5 2 0.340011 8.13606 5.84126 -7.49685 -0.624375 38.3142 -6 2 0.514278 7.70743 7.38333 14.5888 -19.2797 9.57425 -7 1 8.47639 18.6969 6.83361 -13.2294 -1.25401 8.78355 -8 2 9.37315 0.218195 6.58559 19.0885 2.32763 -3.91705 -9 2 7.98208 0.748711 6.39478 -2.33131 3.58411 -1.86541 -10 1 6.52812 1.78346 11.693 -34.4751 -1.18092 9.20038 -11 2 5.67737 2.21709 12.0036 34.6116 -15.9045 -8.19534 -12 2 6.27488 0.856486 11.479 2.31906 19.7771 3.09659 -13 1 7.04596 5.66579 2.40189 46.2065 -42.3734 -14.42 -14 2 6.39782 6.00892 2.95716 -37.9245 28.3982 32.5204 -15 2 6.93615 6.04049 1.54428 -8.317 15.9019 -18.5798 -16 1 16.2302 10.236 16.0835 20.9593 -16.5275 2.4245 -17 2 17.1756 10.4542 16.2372 -23.2351 0.455296 -7.02457 -18 2 15.6872 10.9657 16.3738 0.757377 12.3052 3.78761 -19 1 10.6519 14.9414 2.32488 9.23959 14.6152 1.78567 -20 2 10.6414 14.4628 3.16471 0.797937 2.29677 -5.70575 -21 2 11.1604 15.7599 2.50148 -7.89724 -14.8548 -1.26363 -22 1 17.1653 8.24769 10.628 -7.00673 -3.15457 9.83212 -23 2 16.8168 8.85992 11.2947 -1.87186 0.196375 -6.64951 -24 2 17.9222 8.68524 10.2369 7.99899 3.60318 -1.68622 -25 1 14.7266 15.9157 16.4191 -13.8739 15.1565 -8.48964 -26 2 13.7936 16.2384 16.3951 24.1732 -8.40377 0.758561 -27 2 14.8582 15.5746 17.3097 -4.06225 -5.68183 -0.795501 -28 1 12.1165 13.3951 0.497647 12.4663 -12.7582 1.83308 -29 2 11.9617 13.3954 18.1814 -7.51799 5.11576 7.21512 -30 2 11.4424 13.8646 1.00511 -0.599491 5.86198 -7.65109 -31 1 9.3022 5.46358 3.98483 37.3 9.28522 -25.3544 -32 2 8.76176 5.25183 4.70521 -26.4917 -13.7331 37.3539 -33 2 8.69012 5.59126 3.27137 -14.2398 -0.31671 -15.324 -34 1 1.75646 4.13824 11.6126 7.13571 -34.631 6.10286 -35 2 1.57168 5.01735 11.8974 -3.49495 27.0073 7.26754 -36 2 2.15491 3.66767 12.3745 -6.50879 7.63382 -13.9832 -37 1 2.03017 6.80422 8.30837 9.29028 16.8447 12.8872 -38 2 2.52076 7.32809 8.97976 -10.1379 -7.93343 -11.4013 -39 2 1.79129 5.98703 8.76166 3.66627 -1.3648 -7.3534 -40 1 5.38278 4.45139 7.96045 1.48715 2.78745 -0.615366 -41 2 5.47525 3.53905 7.69237 2.73507 -15.0654 6.73754 -42 2 4.91072 4.84535 7.233 -11.388 9.54401 -10.9371 -43 1 3.30811 2.94776 17.4802 13.944 -42.282 -21.1312 -44 2 3.9986 3.21817 16.868 2.68053 3.29728 -0.298822 -45 2 3.01647 3.72731 17.8911 -19.397 34.8415 21.3069 -46 1 7.43048 5.35311 6.10326 -4.25319 -13.0158 -27.7806 -47 2 8.09022 5.89476 6.48364 23.034 26.3027 15.5228 -48 2 6.99872 4.97144 6.84559 -15.3695 -14.0963 19.964 -49 1 9.79676 7.01231 12.0156 -14.7328 3.59156 -15.7655 -50 2 10.3705 6.43202 11.4882 -9.23999 6.31012 5.56299 -51 2 9.04301 7.2927 11.4294 23.3546 -9.34629 13.9639 -52 1 14.0089 3.6286 8.06931 13.5755 5.11429 34.4728 -53 2 14.0074 4.36435 7.46412 -2.30693 7.62473 -7.33974 -54 2 14.3705 4.00595 8.91563 -10.4749 -13.1534 -24.8623 -55 1 4.55657 17.1558 3.95973 -9.28017 -24.3455 25.7085 -56 2 5.47914 17.3407 4.055 21.0307 11.7367 -4.03215 -57 2 4.1348 17.6911 3.31263 -3.95253 16.2794 -25.0192 -58 1 16.4751 16.614 10.2504 -32.3258 -7.85569 21.4695 -59 2 15.6275 16.6356 10.7813 29.977 2.99208 -16.9651 -60 2 16.2718 15.9944 9.53771 -1.01186 4.78751 -1.5712 -61 1 1.9619 4.81867 0.319959 -10.9755 -9.70287 -18.0846 -62 2 2.61752 5.08919 0.942567 15.1261 9.15008 18.4356 -63 2 1.74644 5.61951 -0.161427 -5.07436 5.04444 -4.19633 -64 1 11.5961 13.2841 16.3358 -4.45358 14.5896 10.2849 -65 2 11.0454 12.5131 16.3954 -10.7816 -16.1685 4.94665 -66 2 12.1536 13.1064 15.5876 11.3576 1.56581 -12.6168 -67 1 10.1325 11.0245 16.8746 -17.0839 37.329 0.881875 -68 2 10.5383 10.188 16.8005 14.1256 -36.2582 -1.95739 -69 2 9.19072 10.9065 16.7053 -0.138929 -3.60954 1.11764 -70 1 11.7656 17.449 13.475 -8.50487 25.248 2.18402 -71 2 12.3632 17.1066 12.8073 4.24528 -3.45864 -2.0733 -72 2 11.8231 18.4283 13.4081 4.57434 -16.4673 0.201387 -73 1 6.41878 9.35136 12.2283 -7.50229 14.2202 21.4939 -74 2 6.8057 8.89086 11.4896 12.6266 0.651555 -6.79619 -75 2 7.09031 9.88696 12.7035 -9.91308 -10.3657 -12.0835 -76 1 16.2619 12.8358 2.69678 7.42582 31.4023 -4.83963 -77 2 17.0939 13.3284 2.51069 -14.3032 -16.3414 4.28546 -78 2 15.5824 13.5473 2.68145 7.19887 -17.4175 4.43499 -79 1 0.698809 12.6212 5.89369 35.48 3.16674 13.5988 -80 2 0.938081 12.5288 4.97754 4.92149 -4.10163 -12.4931 -81 2 18.4194 12.7439 5.90006 -39.8609 3.63618 -4.1467 -82 1 5.237 16.4363 18.426 1.65878 -0.316472 9.22308 -83 2 5.81108 15.7548 18.0954 4.21498 -13.4949 -13.2329 -84 2 5.56972 16.5656 0.670239 -4.67124 7.34541 5.05152 -85 1 0.592121 7.69947 4.15467 -58.6061 -26.6762 36.9237 -86 2 18.6393 8.0928 3.5307 -12.7545 6.31849 -14.8448 -87 2 1.4218 7.85573 3.82511 72.6481 19.3185 -25.9209 -88 1 3.11983 8.96532 6.48794 54.6199 12.7003 -22.2767 -89 2 3.76913 8.45297 6.98254 -4.7725 1.8296 2.92636 -90 2 2.27977 8.75705 6.803 -46.0396 -12.4219 19.8369 -91 1 7.29807 10.3702 16.2638 20.6686 -0.114663 -24.6428 -92 2 6.66655 10.506 15.5642 -5.16108 2.7891 -5.34334 -93 2 6.78521 10.2638 17.0451 -10.3715 -1.64006 24.8745 -94 1 11.1174 0.987619 5.00277 -7.18116 3.53088 7.25248 -95 2 11.0089 1.86145 4.60844 7.25629 1.31859 -0.585836 -96 2 10.7387 0.391071 4.35918 -2.65397 -7.99376 -8.61355 -97 1 4.35641 2.82374 13.2083 -1.43301 42.1246 -29.6721 -98 2 4.74578 3.12447 14.0221 1.91906 -0.955597 13.0676 -99 2 4.17771 1.91012 13.264 -5.21231 -41.1093 14.0839 -100 1 8.41102 10.1748 1.81577 -7.29686 12.4487 -22.3398 -101 2 8.22152 10.8552 2.46036 0.4991 6.95458 5.373 -102 2 8.69583 9.43786 2.3232 10.7851 -24.1065 14.6426 -103 1 10.4306 1.70557 15.5491 18.4702 5.47966 -9.86629 -104 2 11.3921 1.67519 15.3716 -14.7227 -5.4908 8.94093 -105 2 10.0695 2.09393 14.7416 -3.28742 -2.92827 -1.64813 -106 1 2.67775 12.9037 7.82287 3.09642 7.69249 12.8714 -107 2 3.27779 13.5956 7.51776 -0.922255 -1.64886 -5.76029 -108 2 2.01429 12.7843 7.13996 -0.0248334 -2.64481 -5.98892 -109 1 3.74038 11.6511 5.07858 19.3958 17.4162 2.05128 -110 2 3.60589 10.7736 5.39333 -4.06789 -18.6575 13.0804 -111 2 3.07486 11.8033 4.42286 -17.2397 4.77378 -8.56343 -112 1 6.72135 14.4316 16.9296 11.8603 14.2358 -0.0778856 -113 2 7.64698 14.6853 17.0511 -5.38436 -3.23295 2.03342 -114 2 6.43726 14.8986 16.1349 -2.65892 -7.20284 -3.09426 -115 1 14.1884 14.544 3.35185 -21.8252 -0.368401 10.0779 -116 2 13.5247 15.1958 3.05461 14.5314 -4.887 4.26149 -117 2 13.7567 14.0734 4.09815 10.0173 4.52685 -16.1607 -118 1 8.41325 18.11 16.0503 -13.4237 14.7481 -2.40694 -119 2 9.01353 17.4146 16.1754 14.4883 -45.0972 12.851 -120 2 9.02228 0.139466 15.7926 3.66197 31.0187 -5.55304 -121 1 4.74026 1.68368 4.91774 -8.81747 -38.2992 48.653 -122 2 3.89365 2.07173 5.09257 -16.8489 9.86366 -0.181142 -123 2 5.05165 2.08173 4.1548 23.8621 30.7653 -48.3713 -124 1 15.012 12.6397 16.4637 21.182 -20.8114 -27.7575 -125 2 14.6363 13.1316 17.1743 -19.1608 12.2632 11.0748 -126 2 14.4002 12.4571 15.7145 4.23163 12.8017 20.733 -127 1 15.7141 18.464 16.8736 -48.8091 1.63943 -48.6642 -128 2 16.4537 18.5656 17.3974 52.451 1.55627 42.8989 -129 2 15.6088 17.527 16.6934 -4.99653 -8.13868 6.26406 -130 1 1.24245 1.19714 16.5568 -3.35795 -9.15112 -9.15157 -131 2 2.06126 1.67967 16.5955 12.2536 9.19 1.95012 -132 2 0.738255 1.56007 17.2754 -9.1343 5.49748 13.2621 -133 1 18.1403 4.48045 15.9024 -8.92064 9.41796 12.6958 -134 2 18.2534 3.91822 15.1507 3.10214 -9.7063 -13.7449 -135 2 0.333051 4.53253 16.3579 6.8431 0.540548 1.72555 -136 1 12.2576 16.9773 16.1451 24.3374 26.4028 -39.8206 -137 2 11.5235 16.7559 16.6626 -39.484 -19.8089 22.2101 -138 2 11.9275 17.1263 15.229 8.36672 -7.61232 16.8746 -139 1 16.0311 2.54163 18.1267 15.2184 -17.5558 18.8253 -140 2 15.6351 3.35325 18.4083 -9.02057 20.5203 4.48377 -141 2 15.9018 2.48695 17.1953 -7.32995 1.76863 -25.4669 -142 1 6.72575 13.8191 10.1968 -9.26978 -14.9128 -14.7006 -143 2 6.45064 13.4802 11.0509 2.35225 3.79258 9.11016 -144 2 6.47529 13.1065 9.58166 7.75573 8.69288 2.20437 -145 1 10.1667 18.3423 2.73278 -21.0918 -24.4685 17.5154 -146 2 10.3808 0.422697 2.17354 8.51297 19.7321 -20.8009 -147 2 9.25877 18.0911 2.47579 12.4496 3.13566 3.08398 -148 1 3.02618 17.7182 6.12046 9.12785 6.17449 -5.85825 -149 2 2.19895 17.4959 5.67953 0.482163 3.05546 -3.6427 -150 2 3.66706 17.9189 5.4073 -11.2068 -9.39986 11.0759 -151 1 12.5962 16.8879 7.98687 8.69067 0.386489 -7.96768 -152 2 11.911 16.2378 7.93697 -12.2796 -18.2514 -9.64148 -153 2 12.3467 17.3792 8.75804 4.49939 18.0195 12.184 -154 1 14.8895 15.2713 8.19847 3.78441 6.77747 -24.1674 -155 2 14.0908 15.8092 8.10802 0.530475 -1.70182 9.59272 -156 2 15.3507 15.4528 7.3473 -4.11878 -7.96121 22.2836 -157 1 17.7044 18.2264 0.345927 53.2191 22.2557 3.1655 -158 2 18.611 17.8064 0.306571 -34.334 1.581 -6.33561 -159 2 17.9464 0.534475 0.465882 -17.8927 -21.106 -0.514669 -160 1 0.816649 10.4426 1.34739 14.8692 48.9775 -23.6448 -161 2 0.0612409 10.0129 1.68761 -29.4632 -23.0248 11.5333 -162 2 0.465717 11.2339 0.843051 15.2672 -28.7963 15.4324 -163 1 1.72991 12.2406 3.39174 -15.9976 -2.88445 -44.3457 -164 2 1.42407 11.5936 2.70825 8.45982 5.87631 22.8389 -165 2 1.72198 13.0652 2.87637 5.68226 -3.3333 12.0496 -166 1 0.611993 17.231 4.90821 -34.3512 10.3394 53.8078 -167 2 18.7649 18.0776 4.93361 14.0145 -8.94618 -14.8948 -168 2 0.320128 16.8659 5.79609 20.9887 -2.41003 -36.5782 -169 1 1.10304 0.897417 9.42158 -11.0752 -12.4205 -5.86027 -170 2 1.33193 0.471936 10.271 -7.8206 6.77035 -10.9921 -171 2 0.260273 0.49253 9.11811 18.1645 10.0729 11.6017 -172 1 16.7431 2.34345 13.2996 -3.12231 -7.25082 27.0749 -173 2 16.9139 2.55723 12.403 6.00909 8.65593 -29.5603 -174 2 16.479 1.41627 13.3001 1.0866 -1.80785 3.13205 -175 1 2.64585 15.864 12.1283 -21.2463 14.7527 -7.08654 -176 2 3.15605 15.3934 12.7599 11.6364 -10.3414 18.5671 -177 2 3.00262 15.6045 11.2815 4.79088 -2.17896 -11.8296 -178 1 16.4298 15.6598 6.07287 -23.7839 -45.9221 18.6798 -179 2 17.316 15.6562 6.39936 21.0579 5.20152 4.08476 -180 2 16.3078 16.3335 5.44341 2.1367 33.4546 -25.3893 -181 1 5.80337 5.0927 11.7988 -16.1764 10.2154 8.68093 -182 2 5.24436 5.75105 12.277 17.1169 -11.9851 -7.24057 -183 2 5.28663 4.27668 11.796 1.81497 4.13117 2.00496 -184 1 15.1635 4.86687 0.779797 10.276 15.6296 -42.8981 -185 2 15.0374 4.47718 1.61189 -4.55383 -15.7546 43.9488 -186 2 14.356 5.34586 0.597493 -2.57536 1.02491 -2.93315 -187 1 16.3458 16.3763 2.04771 3.47576 3.66541 23.8501 -188 2 16.2044 16.7006 2.97252 -3.72753 -7.68524 -25.3267 -189 2 16.7389 17.1226 1.58867 -0.552753 3.82143 -4.99822 -190 1 0.255881 4.83863 3.82235 -11.3764 -61.9515 -5.66134 -191 2 0.347221 5.7447 3.93716 8.7619 60.1171 8.48532 -192 2 0.834328 4.39842 4.45398 2.37129 4.71095 -1.99834 -193 1 2.9563 15.0569 15.1257 1.71124 8.82343 -41.1566 -194 2 2.85861 14.8634 16.033 -5.32392 -14.5435 34.6784 -195 2 2.48389 15.8911 15.0234 3.12674 0.885842 0.387353 -196 1 1.13777 14.6522 9.5263 -30.3315 0.106042 24.0606 -197 2 1.89024 14.3075 9.07024 17.4708 -15.5826 -4.95385 -198 2 0.933623 14.0402 10.2733 8.29602 9.54759 -23.1661 -199 1 13.5292 16.584 11.5416 25.6454 -21.6132 21.0377 -200 2 13.328 17.2834 10.9465 -13.4726 19.9213 -18.5602 -201 2 13.2496 15.765 11.1158 -9.99742 3.11837 -0.28929 -202 1 4.66126 1.44669 0.76776 24.0608 13.759 -10.2694 -203 2 4.19513 2.00271 0.14116 -5.95148 5.85957 -2.67997 -204 2 4.06121 0.755814 1.00952 -11.6339 -11.0076 11.757 -205 1 1.46276 18.5641 11.8468 9.16484 -20.9655 21.4802 -206 2 1.29795 0.448688 12.6433 2.09315 -1.75191 -4.75625 -207 2 1.84947 17.7191 12.1761 -6.39306 18.521 -9.12508 -208 1 11.4915 10.1299 3.99438 -29.0311 -19.3551 44.8744 -209 2 11.2201 10.4871 3.17848 -8.25775 15.5063 -35.6965 -210 2 12.4189 10.233 4.02648 37.0944 1.09916 3.99775 -211 1 8.27499 12.1796 3.66337 18.6814 -7.12196 -36.2468 -212 2 9.0689 12.5922 3.98877 11.875 7.24467 3.22649 -213 2 7.6764 12.2152 4.36849 -32.1167 2.17346 40.1921 -214 1 14.4874 4.01368 3.28039 -17.5005 -0.0616197 -21.9184 -215 2 14.9648 3.93911 4.08552 21.5727 -0.139675 21.9436 -216 2 13.7566 4.60071 3.48465 -5.84393 1.34015 1.64127 -217 1 5.62374 1.66322 7.51635 70.0554 58.4457 -44.6253 -218 2 5.02312 1.16941 7.9611 -67.4835 -53.4064 45.1295 -219 2 5.39821 1.60037 6.57846 0.425083 -1.20148 0.902483 -220 1 17.8844 1.0604 4.85627 -10.0966 -7.93422 8.12116 -221 2 18.57 1.49808 4.37578 15.6561 4.82809 -15.3219 -222 2 17.6975 1.64814 5.58583 -4.12013 1.11537 7.77052 -223 1 6.80576 9.4106 4.49942 14.9318 -4.14838 16.3077 -224 2 6.92469 9.61899 5.44741 -8.81338 -3.93454 -14.2946 -225 2 7.68422 9.10473 4.22333 -4.88591 1.73472 -0.668879 -226 1 2.61188 14.876 1.98504 -6.91902 -4.93882 19.1315 -227 2 3.25848 14.7083 2.68056 -2.68924 0.660774 0.84214 -228 2 3.12462 14.9058 1.19269 5.2127 1.18228 -19.2613 -229 1 17.303 12.9246 13.1525 10.3788 -12.5807 -3.95397 -230 2 16.4389 13.2985 13.3385 -0.36563 10.0164 -0.276732 -231 2 17.9169 13.6449 12.9311 -14.7092 -1.11942 1.9762 -232 1 14.9246 10.553 1.38722 24.8563 30.4026 18.8772 -233 2 15.5245 11.2788 1.76222 -27.4309 -28.2887 -15.3922 -234 2 14.0162 10.8271 1.54897 4.06804 -0.689498 -1.36825 -235 1 5.72717 6.70809 4.58418 -6.56467 23.581 -8.85087 -236 2 6.06385 7.62371 4.66236 -8.01259 -10.4186 -5.73866 -237 2 6.2767 6.1943 5.16785 8.48743 -6.29877 6.22452 -238 1 8.0009 8.33508 10.3687 14.1913 1.83663 -35.3126 -239 2 8.52082 9.13006 10.161 -0.0651459 -5.63876 7.89795 -240 2 7.94932 7.91253 9.48819 -6.75295 -2.00865 18.056 -241 1 13.4409 18.4268 5.72382 16.6357 0.722738 -15.7997 -242 2 12.6296 0.221713 5.47389 -5.04693 11.9449 -2.85301 -243 2 13.1936 17.8965 6.46343 -5.47963 -14.8645 21.1785 -244 1 0.0859293 2.63743 0.236192 -9.12202 -35.143 -2.56963 -245 2 17.9325 2.9505 -0.168165 -24.3821 -4.07692 -4.34214 -246 2 0.590564 3.4143 0.297916 33.333 32.0117 7.87133 -247 1 12.8395 11.0444 9.74231 45.1743 -31.9509 26.4779 -248 2 11.9686 11.0602 9.42407 -43.5447 -1.91263 -10.9888 -249 2 12.9558 10.1388 10.1456 -3.41612 23.6256 -14.6869 -250 1 0.710059 12.1592 11.0756 -10.531 -0.362272 -11.4251 -251 2 18.3753 12.1255 11.106 13.0957 4.94421 7.25875 -252 2 1.07349 12.4339 11.9177 -3.83141 1.58371 11.017 -253 1 5.10203 7.3136 13.4291 15.7719 5.5957 -0.396148 -254 2 5.6162 7.93373 12.8769 -6.75271 -3.40235 8.70115 -255 2 5.62723 7.25347 14.2483 -7.64248 -3.9813 -9.01905 -256 1 1.21129 6.85545 11.8946 29.9494 36.4661 12.0403 -257 2 0.485742 7.25442 11.415 -4.88796 -0.516932 -2.56673 -258 2 1.80546 7.64481 12.127 -26.2797 -36.2571 -7.59378 -259 1 15.5076 9.61367 12.3051 21.7085 -42.1446 -13.9552 -260 2 15.1772 10.4675 12.1584 -16.5272 42.565 -1.064 -261 2 15.3545 9.37182 13.2055 -3.21788 1.51701 18.7315 -262 1 16.6116 12.7513 5.5295 7.16384 -7.58562 22.1279 -263 2 16.3878 13.6701 5.61583 -3.61437 18.1746 3.54477 -264 2 16.4616 12.5615 4.61757 -3.38991 -5.42355 -25.0954 -265 1 6.3014 9.86096 0.0280098 12.3864 1.00447 14.78 -266 2 5.6246 10.4136 0.42972 -1.13337 -0.2267 2.50286 -267 2 7.03571 9.82087 0.686012 -15.2579 5.10695 -14.0237 -268 1 12.3034 6.12839 4.06739 18.1147 15.8957 -28.6536 -269 2 12.3348 6.66771 3.23063 -4.28261 -10.1618 29.3394 -270 2 11.5855 5.52112 3.9529 -14.8183 -8.35162 -1.01689 -271 1 0.289245 12.8118 0.17396 1.00074 4.7721 1.62068 -272 2 0.031574 13.4709 0.828681 0.933398 1.09562 1.96647 -273 2 18.4473 13.0492 18.0252 -3.3255 1.79332 -7.06642 -274 1 3.67377 18.6092 8.59256 -12.2718 12.3972 8.90671 -275 2 3.51633 18.2244 7.72678 0.0355868 -3.61867 -2.60117 -276 2 2.80982 0.36536 8.82196 13.0622 -5.69839 -0.636093 -277 1 7.44701 17.3263 4.47819 -12.2479 -42.1382 8.27198 -278 2 7.47198 18.2285 4.71954 7.46065 34.1282 3.2472 -279 2 7.59543 17.2523 3.54279 -0.328999 6.68987 -14.4609 -280 1 9.24493 17.1077 12.2387 -39.9724 15.9122 -7.56371 -281 2 9.27102 16.3677 11.6468 4.90539 -16.8252 -9.88175 -282 2 10.091 17.2207 12.6154 35.0883 -2.17581 15.9571 -283 1 13.2831 12.983 8.01599 31.7457 23.9761 -1.258 -284 2 13.3856 12.1913 8.53584 -3.88389 -9.78552 5.15809 -285 2 14.1414 13.4672 8.16531 -29.1617 -3.59582 -8.01118 -286 1 14.8948 2.98524 15.3712 -17.5751 0.764594 21.5491 -287 2 14.1876 2.34218 15.2724 -1.25262 -5.58382 2.64656 -288 2 15.4061 2.89645 14.5861 17.2961 2.13088 -20.5882 -289 1 9.89537 15.5662 16.9902 -4.09035 4.17693 9.89685 -290 2 10.2983 14.7234 16.7502 5.73332 1.10161 -2.59445 -291 2 9.67249 15.5035 17.9343 -2.60097 -1.56266 -9.87078 -292 1 11.3274 8.38795 16.5853 -21.4847 -13.5698 4.02619 -293 2 10.6433 7.93033 16.0536 12.1725 7.69909 5.41873 -294 2 11.2563 7.95351 17.4557 6.17465 6.37506 -11.4872 -295 1 3.9593 18.2162 16.7697 0.697619 -14.1615 -14.1273 -296 2 4.40283 17.477 17.2226 -3.01571 14.2153 3.03122 -297 2 3.77495 0.26362 17.3949 3.98021 5.349 11.1126 -298 1 2.22376 4.19593 8.92134 -23.2189 1.10906 -21.9008 -299 2 3.13693 4.25168 8.71451 27.6214 0.869066 -8.80864 -300 2 2.192 4.13003 9.85498 -3.77747 -6.53541 33.4183 -301 1 9.87956 10.3806 9.72418 15.1316 -34.7661 11.7533 -302 2 9.43202 11.1334 9.41625 -17.3542 37.4051 -17.5479 -303 2 10.0318 10.5223 10.6578 4.66737 -1.93825 10.7585 -304 1 9.70627 0.903434 10.8708 -16.6391 -17.8124 -8.64764 -305 2 9.32253 0.0380009 11.0933 9.22807 5.63208 7.52542 -306 2 9.08638 1.2149 10.1967 9.10725 8.78511 -0.274781 -307 1 9.19757 15.1031 10.2247 30.2853 16.2782 3.75492 -308 2 8.7691 15.7671 9.69642 -6.57671 14.9232 -6.79792 -309 2 8.58248 14.3993 10.2376 -24.9838 -23.9988 3.33467 -310 1 0.938497 9.56303 10.2766 -19.6808 1.12411 10.869 -311 2 0.864208 10.4264 10.69 -4.58503 2.29603 -0.877129 -312 2 1.8082 9.5891 9.92621 21.6362 -6.44505 -13.6115 -313 1 17.0002 4.85339 8.15215 21.2107 4.17599 -32.9154 -314 2 16.5226 5.60356 8.44909 -16.9553 23.1583 5.35412 -315 2 16.856 4.21761 8.81327 -1.81027 -27.4365 28.1652 -316 1 14.7301 14.7112 0.178334 14.6842 0.804622 -15.2869 -317 2 15.1474 15.2511 0.844024 6.42123 6.45952 11.8737 -318 2 13.9865 14.3021 0.591484 -20.7841 -7.92944 9.37323 -319 1 3.69091 11.0487 9.53568 5.98335 -8.96355 13.8332 -320 2 3.56651 11.2839 10.4631 4.16949 4.48414 3.3219 -321 2 3.23005 11.7193 9.04032 -8.2098 7.45463 -11.8198 -322 1 11.2005 10.7579 1.45634 -8.62161 -19.8695 4.90197 -323 2 11.5404 11.5862 1.17391 12.694 26.4047 -12.3165 -324 2 10.2904 10.7467 1.15081 -4.44873 -2.97897 0.910453 -325 1 13.1494 7.14877 12.735 25.4211 -2.46103 0.847156 -326 2 14.1287 7.02261 12.7655 -19.3043 2.68773 1.11168 -327 2 12.7806 6.27183 12.8763 -3.1166 -1.04351 -1.25783 -328 1 9.62343 1.89491 0.979311 -12.9604 6.63616 -29.4885 -329 2 8.7946 1.64267 0.49669 19.6199 4.62861 14.6045 -330 2 10.1494 2.42868 0.345455 -5.12075 -11.8177 11.3147 -331 1 10.6335 13.514 4.5646 -17.0056 -0.486025 -1.57099 -332 2 11.3585 12.913 4.68456 17.6411 -7.84828 -0.965736 -333 2 10.6299 14.042 5.36013 -0.769181 5.74096 10.189 -334 1 14.4133 1.73933 10.9414 -11.8391 -17.207 6.29742 -335 2 15.2077 1.35218 10.5638 5.14778 2.73806 -3.87278 -336 2 14.5015 2.69292 10.9149 5.22965 5.71868 -2.86675 -337 1 14.5722 12.1975 11.686 14.094 -1.05888 37.2495 -338 2 15.3017 12.3928 11.129 31.2021 7.92611 -10.369 -339 2 13.8916 12.0994 11.0714 -43.9062 -9.54665 -27.6985 -340 1 8.20779 5.06885 9.81189 17.2837 -27.279 -13.9945 -341 2 7.476 5.2926 10.3565 -21.7486 9.79802 13.7153 -342 2 8.11585 4.0945 9.69767 5.61634 21.6585 -4.44102 -343 1 1.51211 16.8659 18.4077 -7.21278 -21.5738 6.32543 -344 2 1.92778 17.2486 17.641 3.99023 3.9685 -12.2343 -345 2 1.4425 15.9033 18.1995 7.9863 23.2313 7.90302 -346 1 1.50475 17.27 15.3217 -52.6385 22.4638 18.049 -347 2 1.49283 18.1952 15.6793 7.67726 -26.1665 -10.1971 -348 2 0.544177 16.9836 15.4083 37.5739 4.67989 -9.3974 -349 1 3.64958 5.72975 6.08508 6.29069 -26.5723 -11.3796 -350 2 3.20343 6.25343 6.73323 -12.457 15.9806 12.721 -351 2 4.14586 6.29176 5.4852 3.70859 6.95385 1.18178 -352 1 12.4272 9.46789 14.1967 -22.2867 60.9428 4.59069 -353 2 12.8141 8.72569 13.8244 25.5413 -52.6107 -24.0302 -354 2 12.2248 9.22264 15.0865 -2.36671 -8.29514 20.866 -355 1 4.05215 15.2773 6.93811 -37.3363 -16.6714 15.1212 -356 2 3.52112 16.0418 6.69595 1.88806 4.21981 -3.16255 -357 2 4.93922 15.5036 6.7631 37.0693 10.9568 -7.31607 -358 1 0.634621 8.6113 14.9988 -1.00168 -8.57623 6.03626 -359 2 0.426563 9.53409 15.1284 -0.450123 11.8509 1.14186 -360 2 1.36493 8.60238 14.3834 7.02364 0.17651 -8.78598 -361 1 12.9488 8.28918 10.2591 -12.3232 2.05195 12.3522 -362 2 13.6164 7.77926 9.80228 8.67745 -2.84232 -3.45719 -363 2 12.9296 7.914 11.161 -0.920073 6.75149 -12.343 -364 1 15.3287 7.72887 3.53701 30.7324 40.0945 -27.1654 -365 2 14.5687 7.40616 3.08394 -23.025 -16.3354 4.19175 -366 2 15.5452 7.39964 4.39595 -10.5646 -17.2283 18.769 -367 1 17.3078 6.69366 0.0430756 19.9915 -9.88107 5.38445 -368 2 16.7705 5.94464 0.294276 -4.0765 -7.9871 3.32428 -369 2 16.6874 7.33606 18.3865 -21.7939 19.8828 -6.94939 -370 1 8.91017 6.93043 7.77699 23.4025 28.7729 -7.70378 -371 2 9.81824 7.33337 7.84479 -23.824 -15.1706 -1.9244 -372 2 8.86104 6.22236 8.40836 -0.772968 -13.4081 16.1446 -373 1 12.3843 0.611213 1.25908 1.98263 -0.697807 -4.79042 -374 2 13.323 0.393307 1.31761 -0.925839 8.32556 5.35041 -375 2 12.1237 0.465738 0.350227 -1.33982 -4.5367 -2.71568 -376 1 5.61465 15.1448 14.5392 -1.26631 -30.1046 6.25467 -377 2 4.66418 15.2406 14.6702 -0.2102 4.52428 0.84195 -378 2 5.97383 15.921 14.1393 5.11494 24.4221 -7.05072 -379 1 3.84895 6.44034 1.72963 2.7696 -8.11358 7.79979 -380 2 3.51864 7.3032 1.48291 -7.06055 11.1725 -5.60147 -381 2 3.99368 6.51729 2.68239 -0.0521329 1.22822 -5.4234 -382 1 3.90083 11.5778 12.3664 -12.9911 -8.32668 -3.5509 -383 2 4.78352 11.9371 12.4749 4.25232 1.56379 3.39016 -384 2 3.29545 12.1182 12.8978 7.28302 -2.19426 -6.07273 -385 1 5.34262 3.87885 15.873 -6.15348 -82.0204 -11.7996 -386 2 6.0076 3.23261 15.5032 -15.8888 19.1459 15.4213 -387 2 5.69117 4.71679 15.7838 27.5644 60.3601 -6.10452 -388 1 14.3156 10.2471 4.51115 -35.9806 40.7967 42.7391 -389 2 14.5125 9.92103 5.39777 -3.50802 -2.54983 -0.445713 -390 2 14.828 9.75135 3.94137 33.3968 -38.7315 -40.7643 -391 1 7.75287 17.3919 9.13705 13.5919 -13.2315 -4.02741 -392 2 6.89819 17.6363 9.44363 -21.9658 0.853712 16.3055 -393 2 7.88604 17.9611 8.38483 9.7933 6.77297 -11.9047 -394 1 4.50916 14.5069 3.91348 -1.14645 -26.1805 -53.139 -395 2 4.48781 15.3883 4.18695 -0.715057 47.311 12.47 -396 2 4.59583 14.0061 4.68593 4.03467 -28.7439 39.2156 -397 1 14.2649 7.40032 15.8248 -22.801 -12.9293 -21.4811 -398 2 15.1988 7.32934 15.7188 25.9215 -1.64325 -3.33443 -399 2 14.1282 7.83404 16.6492 -0.714938 9.98648 22.5393 -400 1 3.02257 18.338 1.93829 -9.63799 -32.7056 -36.1055 -401 2 2.55646 17.7535 1.2554 15.187 19.9859 31.9951 -402 2 2.37728 0.279403 2.32429 -11.6166 9.08866 3.80637 -403 1 7.9856 1.63208 4.58686 -21.2194 7.37107 -10.8429 -404 2 7.46714 2.08087 3.89599 -2.9365 -3.17783 11.7342 -405 2 8.82293 1.5175 4.16848 19.7493 -4.53145 -2.81354 -406 1 2.46603 14.1528 17.6814 26.4379 24.7021 -16.3984 -407 2 1.84119 13.6421 18.1459 -27.3849 -25.1212 16.5566 -408 2 3.3203 13.7773 17.9154 6.17156 -2.74614 2.81365 -409 1 0.847673 1.77812 13.8995 -29.1857 4.71799 7.40329 -410 2 0.70153 1.57851 14.8469 9.71331 1.1605 -15.3576 -411 2 18.5888 1.96886 13.5517 20.2657 -3.94578 7.10705 -412 1 4.44078 18.6823 13.9019 -16.0244 4.84661 7.61196 -413 2 5.30649 18.3093 13.8135 20.8517 -5.19628 -2.25594 -414 2 4.21344 18.5423 14.8331 -2.2181 0.553195 -4.50589 -415 1 7.17333 0.707602 18.3659 18.5924 -14.7376 -19.2949 -416 2 7.29313 0.222373 17.5065 -5.17699 16.3575 23.4569 -417 2 6.28409 1.05221 18.4099 -11.4153 -0.902781 0.0516699 -418 1 16.0458 18.3995 13.9929 19.922 2.02833 15.0786 -419 2 15.1358 18.307 13.8248 -34.099 -5.52537 -15.9309 -420 2 16.0494 18.5146 14.948 8.19193 5.7614 4.60276 -421 1 10.1078 4.56818 16.2539 38.806 25.935 -8.65561 -422 2 11.0636 4.83663 16.0361 -35.078 -16.4147 14.4025 -423 2 10.0818 3.61692 16.3176 2.43484 -11.3153 -3.34335 -424 1 15.9163 17.7591 4.46968 32.0074 -29.6155 -15.1132 -425 2 16.5099 -0.143617 4.50341 7.95185 14.4383 0.237761 -426 2 15.1003 18.0575 4.79025 -43.3278 16.7712 13.4837 -427 1 7.00774 17.4246 13.8321 -56.0949 -7.97771 -22.4327 -428 2 7.49162 17.6994 14.5684 25.5375 13.311 41.1471 -429 2 7.64463 17.2266 13.1734 23.6351 -3.93018 -21.4132 -430 1 13.2756 6.47326 6.61789 23.4956 20.1255 -14.8261 -431 2 14.0898 6.99784 6.40679 -18.3755 -16.6425 15.9473 -432 2 12.9103 6.33261 5.73881 -7.54238 -3.20295 2.17295 -433 1 7.79764 2.32743 9.30513 0.620653 -0.611916 41.3127 -434 2 7.26457 2.16571 10.1169 11.5422 6.28076 -11.6799 -435 2 7.22158 2.07024 8.60986 -14.5852 -6.72752 -26.4814 -436 1 15.1722 14.8472 13.687 6.75051 -12.1688 -2.41191 -437 2 14.9232 15.197 14.5358 -2.94711 1.82763 14.9216 -438 2 14.8185 15.4404 13.0388 -8.36185 8.62669 -11.0165 -439 1 9.38377 8.31795 3.7734 -21.5197 15.3047 -10.1967 -440 2 10.1883 8.66352 4.14356 14.5642 4.86611 3.27566 -441 2 9.4002 7.3753 3.8765 5.94621 -16.0238 5.03493 -442 1 17.77 13.5913 16.4331 -7.58631 -31.5789 18.0626 -443 2 16.8485 13.2919 16.3991 0.887673 4.05725 -0.920823 -444 2 17.783 14.4232 15.9937 -0.095827 22.773 -14.6224 -445 1 4.93053 10.5741 2.80353 -17.5831 18.6377 -10.1976 -446 2 5.6584 10.2884 3.33403 15.5926 -12.1878 10.3648 -447 2 4.56303 11.3186 3.30761 3.36544 -9.45409 -4.10473 -448 1 3.72361 8.36764 10.1215 3.29328 14.9495 -8.98506 -449 2 3.89363 9.29817 9.8724 -2.16289 -13.6958 -0.787578 -450 2 3.61222 8.39575 11.0685 -3.0862 -1.08413 10.2171 -451 1 15.9739 6.97387 6.06952 -13.2047 20.7109 0.201327 -452 2 16.7663 7.43242 6.33309 11.9845 5.69104 3.28059 -453 2 16.2425 6.10629 5.81378 6.71976 -25.6546 -0.898294 -454 1 15.1226 7.10933 9.08497 -8.54326 -39.6564 44.8588 -455 2 15.7377 7.52152 9.6861 12.0306 8.12876 4.18876 -456 2 15.1451 7.58697 8.30383 2.04885 32.3579 -51.8464 -457 1 6.29947 12.9646 12.7695 3.37722 -4.66482 -6.66232 -458 2 7.17165 12.6249 12.9809 1.24175 -10.0492 1.61343 -459 2 6.12977 13.6114 13.4445 -6.34808 15.4581 9.54933 -460 1 12.1164 4.51054 13.0962 -37.6646 -34.1548 1.17408 -461 2 12.2607 4.59773 14.0409 7.03003 6.16295 4.50476 -462 2 11.318 3.89029 13.036 30.5495 29.2935 -6.64922 -463 1 11.3767 8.15056 7.89733 -18.501 8.72492 -14.0328 -464 2 11.9999 7.57003 7.45959 11.3303 -6.40222 -0.944592 -465 2 11.6722 8.28384 8.79215 9.56916 -2.23029 14.0742 -466 1 17.1624 10.8628 7.5038 -34.939 16.2827 29.0255 -467 2 17.7665 10.1757 7.31962 29.6392 -23.074 -13.6235 -468 2 17.1223 11.4937 6.79065 1.17945 1.22203 -15.4432 -469 1 5.28569 18.1322 10.989 31.979 0.201705 -2.44437 -470 2 4.81806 17.865 11.7612 -14.4656 -7.34411 17.8618 -471 2 4.63582 18.2948 10.3295 -20.6991 2.34913 -21.9288 -472 1 7.59755 17.5197 1.78957 -4.56355 -5.70379 -23.6831 -473 2 7.90081 16.7255 1.29504 -6.23989 15.492 10.1621 -474 2 7.18064 18.108 1.12072 15.1074 -6.58967 11.1205 -475 1 1.93009 12.8809 13.5782 -3.15102 -7.76664 -18.9393 -476 2 1.45787 12.3423 14.2065 -6.90584 -5.9659 9.51664 -477 2 2.19823 13.666 14.0335 5.43227 17.0545 14.7464 -478 1 9.58089 6.76558 14.8178 3.72821 -35.8509 -10.9213 -479 2 9.75861 5.80832 15.0417 -6.66727 32.4051 0.0155959 -480 2 9.77461 6.83059 13.8656 0.408011 6.2359 8.07479 -481 1 15.2957 4.27102 10.7659 9.27088 14.9202 31.1326 -482 2 16.1322 3.95288 11.1528 -7.49935 1.06904 -21.0932 -483 2 15.0846 4.9939 11.387 -3.9034 -8.13187 -14.3813 -484 1 11.2455 6.18064 0.162868 26.0255 26.7031 14.5737 -485 2 11.4763 5.37121 18.3763 -4.81733 -21.4086 -8.3593 -486 2 10.308 6.3098 0.211594 -20.2553 -5.22819 -8.60243 -487 1 0.00824002 11.3791 15.0352 26.3856 -8.14992 32.1511 -488 2 18.096 11.5216 14.3022 -25.0888 8.62779 -34.0528 -489 2 -0.201285 12.127 15.606 2.8625 2.75044 1.90901 -490 1 7.02689 9.25213 7.27678 19.2929 16.5016 -4.78745 -491 2 6.59278 8.51389 7.67295 -14.5933 -20.8184 8.5158 -492 2 7.9603 9.00351 7.26624 -3.73747 1.30273 -1.02295 -493 1 18.3276 15.3446 12.3362 -3.78489 -4.33158 3.75643 -494 2 0.608087 15.5074 12.1532 11.0792 5.95639 -3.98767 -495 2 17.812 15.8736 11.72 0.968766 1.6464 -4.64437 -496 1 16.5183 4.40219 5.2766 -9.25512 24.5768 -59.2644 -497 2 16.7942 3.98653 6.05327 18.9035 -16.7679 44.3388 -498 2 17.2936 4.55111 4.6869 -10.7937 -7.24122 14.527 -499 1 17.7074 3.16435 10.7411 -7.07567 -19.8863 -1.17515 -500 2 18.5775 3.40914 11.0222 18.8337 10.6004 6.41913 -501 2 17.8312 2.27039 10.3862 -7.09349 4.4518 -2.20884 -502 1 12.3002 -0.0151335 10.1074 11.0606 -47.8945 -14.4391 -503 2 11.4203 0.251866 10.2671 -34.8312 14.3717 9.25421 -504 2 12.8296 0.729107 10.2725 26.3435 36.9272 6.71278 -505 1 10.377 9.78 12.4264 -19.0889 -11.9366 -11.7107 -506 2 11.0349 9.79085 13.1125 14.2042 0.527855 9.4859 -507 2 10.1856 8.83311 12.286 4.63513 11.4958 0.11243 -508 1 0.612468 2.80552 7.03105 -3.16196 -18.6605 -12.6623 -509 2 0.888173 3.44011 7.68312 3.89236 7.11247 14.3448 -510 2 0.935234 1.94488 7.34043 -2.08916 10.0979 2.30791 -511 1 0.333274 15.3197 6.88029 -14.1577 45.9776 55.0939 -512 2 0.45846 14.8119 7.69617 1.50982 5.91417 -3.14315 -513 2 0.483825 14.7581 6.18064 16.8578 -51.3136 -47.9608 -514 1 17.0479 7.0004 15.1603 7.32733 3.15391 4.0553 -515 2 17.7743 7.62519 15.0492 -4.65368 3.90748 -3.79045 -516 2 17.4843 6.26113 15.5911 -6.30626 -9.6282 -1.63315 -517 1 9.09335 12.4409 8.06571 39.5186 -12.5139 -7.54936 -518 2 9.34597 11.7249 7.45783 10.9221 9.9246 5.15013 -519 2 8.17581 12.4072 7.99758 -53.4732 7.6014 3.58329 -520 1 1.26136 1.81045 2.95361 -2.6705 2.40839 8.80735 -521 2 0.548126 2.01955 2.35817 -5.69651 1.92544 -13.4687 -522 2 1.50342 2.66138 3.33407 8.35517 -3.762 3.05283 -523 1 4.10861 15.1005 9.87028 17.6559 -3.6711 -5.25272 -524 2 3.99986 15.4157 8.96812 -4.49733 0.314881 -1.79245 -525 2 5.04559 14.8362 9.90181 -11.0653 1.71965 6.05025 -526 1 7.3044 2.18074 14.6544 -4.4599 -5.38687 1.90914 -527 2 7.13921 1.65822 13.8561 -1.41133 5.62984 3.30149 -528 2 7.58548 3.05039 14.3636 5.58134 3.87352 -5.39735 -529 1 18.5311 14.6245 2.16796 -28.4168 7.73599 -0.688338 -530 2 0.75601 15.0339 2.21782 2.27339 5.70314 -0.294719 -531 2 17.8249 15.3246 2.17516 22.0369 -13.9852 -0.651534 -532 1 9.98569 2.74939 12.8982 -9.19221 10.3282 12.793 -533 2 9.83979 2.05829 12.2602 3.07064 -9.86428 -11.8695 -534 2 9.16543 3.26718 12.8794 9.24196 0.527571 1.01071 -535 1 2.93657 8.90297 13.0427 17.8365 13.1008 0.527628 -536 2 3.20967 9.8454 12.9227 -4.18066 -20.4527 0.554358 -537 2 3.74278 8.43516 13.3493 -16.2822 5.83343 -3.94486 -538 1 3.21464 8.50963 3.72772 0.0178718 14.8284 -74.1155 -539 2 3.59865 9.33251 3.32895 -6.0017 -25.5341 4.84747 -540 2 3.33657 8.62148 4.62381 5.38554 5.83243 67.2306 -541 1 5.61344 7.20035 8.58446 -2.8239 -8.19112 0.0562215 -542 2 5.53456 6.24006 8.54079 8.61958 1.67382 -4.34837 -543 2 5.04066 7.41711 9.32304 -1.21443 9.5719 0.536432 -544 1 14.8964 1.44105 1.93253 -7.61412 -10.5809 19.4064 -545 2 14.4541 2.19461 2.37874 12.2686 -5.42452 -16.4906 -546 2 15.2548 1.628 1.06483 0.86569 15.045 -4.43663 -547 1 8.4154 15.1546 0.810786 1.70028 1.58395 -11.225 -548 2 9.17382 15.0707 1.40016 -1.99176 -3.13146 6.02583 -549 2 7.70673 14.5929 1.15135 2.54266 -0.476233 4.63029 -550 1 15.567 1.36482 7.20444 28.1778 15.3746 16.2283 -551 2 15.0185 0.765154 6.74682 -23.3742 -21.8939 -17.7163 -552 2 14.9729 1.99808 7.60632 -6.19001 12.1291 -0.330309 -553 1 5.0089 13.0207 18.4853 -18.4609 -5.74542 -15.9738 -554 2 5.42479 13.0864 0.690362 9.95106 2.52519 17.0862 -555 2 5.65544 13.3331 17.8473 1.85993 1.51979 0.712767 -556 1 15.3671 8.54929 18.1095 -8.15636 -15.968 22.0227 -557 2 15.6817 9.03573 17.3686 11.3034 18.5085 -22.2724 -558 2 15.31 9.18561 0.190372 -2.38163 -0.236806 -1.34825 -559 1 12.0802 3.07221 18.3457 4.60183 -13.894 -6.42275 -560 2 12.4859 2.4 0.260392 -4.96838 8.65649 13.1594 -561 2 12.2775 2.7013 17.4791 -3.58827 6.63097 -2.22236 -562 1 13.1993 12.6855 5.15579 5.61247 -4.39703 15.9491 -563 2 13.8115 11.9693 4.94018 -5.07495 0.365899 -6.13845 -564 2 13.2564 12.743 6.12308 -1.32671 2.90452 -5.88021 -565 1 6.08204 7.19061 0.120725 -6.90673 14.7019 -8.65455 -566 2 5.87336 8.13986 -0.0835188 5.89552 -25.7895 13.7146 -567 2 5.2676 6.79179 0.465292 5.04542 5.75855 -0.526985 -568 1 17.7014 15.9063 14.9696 22.6091 -4.25312 7.62853 -569 2 16.8618 16.3646 15.0156 -4.32677 -2.50983 -14.3551 -570 2 17.9392 15.6583 14.0532 -15.4152 10.9643 9.19951 -571 1 13.1673 0.955706 16.6058 -16.4624 13.9879 0.0318296 -572 2 14.0199 0.765403 16.9805 16.2653 -3.85138 1.37902 -573 2 12.7278 0.106773 16.5459 -0.203322 -8.12911 -4.60325 -574 1 10.9967 14.5844 7.33958 -18.0316 -21.646 7.99268 -575 2 10.1705 14.1548 7.70673 29.6081 10.2394 -10.7243 -576 2 11.7328 13.9554 7.47718 -10.5059 7.23567 0.829732 -577 1 17.5629 8.52802 2.09087 -9.01192 -26.3923 -8.78708 -578 2 16.6633 8.41226 2.4486 12.6056 4.50253 0.467713 -579 2 17.6588 7.73531 1.50133 0.834193 24.7006 12.2923 -580 1 12.3809 7.87992 1.9744 6.05515 -15.9846 -5.53898 -581 2 11.7749 8.59773 2.10936 -4.35558 14.0343 4.46215 -582 2 11.9629 7.32605 1.30246 4.89043 0.565697 0.45699 -583 1 11.9793 14.6347 10.4335 18.2405 9.923 28.253 -584 2 12.2756 14.1199 9.71871 15.2703 -21.0335 -29.0838 -585 2 11.0615 14.7405 10.2767 -32.5541 7.66631 -1.56623 -586 1 6.81522 6.956 15.5295 -17.6641 -14.7432 -7.98444 -587 2 7.71149 6.86909 15.2553 24.3623 -4.30517 -12.3513 -588 2 6.87971 7.6292 16.1782 -5.40685 18.4787 21.7047 -589 1 8.03389 4.5887 13.4155 -37.171 -3.64226 -22.5123 -590 2 7.25568 4.78495 12.82 23.9185 -7.87368 18.6792 -591 2 8.43341 5.43391 13.5743 6.319 9.72574 1.79505 -592 1 13.4002 12.1853 14.3374 -4.54681 1.91445 -1.84351 -593 2 13.053 11.3082 14.1695 -1.05297 -9.08012 2.89826 -594 2 13.8525 12.4201 13.5231 2.34057 5.70396 -2.70792 -595 1 14.6576 9.49709 7.25838 9.71531 18.8932 28.1379 -596 2 15.5128 9.94191 7.46983 -15.999 -8.53149 -8.43731 -597 2 14.0596 9.76702 7.98865 8.11873 -7.0154 -18.3951 -598 1 12.7312 16.9238 3.19475 21.2814 -46.1617 -18.4213 -599 2 12.8913 17.1254 4.09275 6.71284 11.8391 31.6773 -600 2 12.0991 17.5238 2.88672 -32.0955 36.7838 -15.6883 -601 1 1.05963 7.10571 17.4007 12.4792 -13.0695 22.2141 -602 2 0.186546 7.34268 17.7101 -8.13154 -6.52047 1.59159 -603 2 1.15324 7.46505 16.5336 -1.37945 14.6986 -20.6467 -604 1 12.8789 5.0234 15.6828 -31.729 4.63914 -0.239626 -605 2 13.551 4.37036 15.6981 25.2388 -22.1242 0.0408259 -606 2 13.353 5.8465 15.7229 6.14669 17.5754 0.411177 -607 1 2.40704 3.36861 5.12193 5.52974 -41.8871 -53.5671 -608 2 1.82145 3.26591 5.8288 -30.6852 -8.64892 41.0269 -609 2 2.78115 4.20498 5.20734 26.4804 50.2953 11.9131 -610 1 8.27515 11.124 13.5771 -2.85187 11.2881 -70.0801 -611 2 8.37295 10.8581 14.431 -1.92558 -15.2628 85.0569 -612 2 8.99363 10.6344 13.1748 6.72692 3.2721 -14.9 -613 1 12.918 1.48119 13.2724 -5.46048 -28.9446 23.2516 -614 2 13.637 1.39783 12.6661 14.6279 -0.945194 -20.1211 -615 2 12.6406 2.36931 13.1901 -10.8983 31.3672 -5.19186 -616 1 6.50945 13.6334 2.15016 9.54562 -3.73103 -23.7728 -617 2 5.85792 13.9589 2.75542 -11.9505 6.96003 17.098 -618 2 7.07728 13.0286 2.63475 0.813075 1.46302 3.43305 -619 1 15.9192 6.52891 12.704 16.1802 17.7634 -8.70325 -620 2 16.3422 7.10874 12.0232 -9.40583 -17.3352 17.4966 -621 2 16.4304 6.67694 13.5293 -11.6709 -4.5663 -12.9766 -622 1 16.8012 0.7168 9.58424 5.37965 28.6432 5.104 -623 2 16.9134 18.4317 9.69441 -4.13374 -28.9785 4.85106 -624 2 16.4797 0.860059 8.69243 -6.31121 -1.15561 -8.50241 -625 1 6.13999 11.6637 8.32406 3.84263 60.0529 3.8669 -626 2 5.34748 11.493 8.80779 -22.31 -6.18549 9.45125 -627 2 6.46273 10.8378 8.08078 19.7827 -51.2376 -16.1138 -628 1 2.82548 8.7059 0.356008 25.1404 7.14145 17.7175 -629 2 2.1872 8.20684 18.5458 -21.47 -27.2684 -27.7438 -630 2 2.28201 9.37487 0.754925 -1.41085 15.0233 10.6798 -631 1 10.1039 10.4509 6.57992 -4.79526 -6.25674 7.70278 -632 2 10.5083 9.74309 7.09516 2.94215 -0.723708 0.948173 -633 2 10.6276 10.5201 5.78606 4.97834 -0.717699 -12.6856 -634 1 6.77313 15.7547 6.63388 -5.578 -17.4503 -5.92282 -635 2 7.15743 16.0375 7.46176 7.11582 8.10879 3.23091 -636 2 7.28529 16.1142 5.89948 -1.84538 11.4125 4.1387 -637 1 6.44197 13.0281 5.69829 11.2984 8.90971 -1.05733 -638 2 6.79679 13.8886 5.97631 -5.91305 -5.55439 0.155281 -639 2 6.12445 12.6032 6.49753 -3.74834 -3.51916 3.00547 -640 1 16.7803 12.5246 9.7433 1.48678 16.9805 10.4147 -641 2 16.9869 12.0132 8.97443 1.49858 -19.0548 -12.8116 -642 2 17.3026 13.3224 9.61445 -4.02823 0.499055 5.20393 -643 1 6.14077 2.94238 2.79674 5.90568 12.9134 -1.15866 -644 2 6.37771 3.87334 2.54509 -6.86675 -27.0997 0.367621 -645 2 5.77601 2.45475 2.03942 1.6023 9.98348 0.439644 -646 1 10.8329 3.18005 3.24633 -5.48645 -3.34604 -3.46544 -647 2 10.1887 3.87164 3.40992 -1.49044 3.74393 4.82403 -648 2 10.5052 2.73309 2.45537 3.4248 -0.0323397 2.60803 -ITEM: TIMESTEP -60 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.78901 6.89398 17.9776 -3.5234 1.93788 3.89787 -2 2 7.91305 7.05712 18.3419 -1.4277 0.241332 2.63834 -3 2 8.67661 6.15674 17.3832 1.3639 -6.15529 -7.04239 -4 1 18.7561 8.31771 6.77309 10.5748 -7.50476 -33.4266 -5 2 0.457617 7.9886 5.89382 -17.7288 16.9324 23.762 -6 2 0.568724 7.76979 7.40723 1.86737 -7.24646 12.6232 -7 1 8.51532 18.7703 6.84705 0.662358 -5.68449 9.56329 -8 2 9.4329 0.211311 6.58737 4.53489 1.21926 -2.36791 -9 2 8.05203 0.803554 6.35578 -1.87482 6.91549 -4.54998 -10 1 6.50103 1.76445 11.707 -23.9337 -6.76257 7.94266 -11 2 5.68898 2.17855 12.0897 23.4576 -7.00878 -10.5629 -12 2 6.21872 0.874053 11.3985 3.54415 20.4784 6.13886 -13 1 7.00577 5.62696 2.40487 20.8008 -18.6778 -13.9491 -14 2 6.3381 5.93149 2.99593 -12.7158 11.2498 18.9927 -15 2 6.96044 6.19487 1.63998 -3.33571 5.44078 -9.1088 -16 1 16.2317 10.2379 16.0906 -2.65398 7.02849 4.45196 -17 2 17.1094 10.623 16.0697 3.52116 -7.47169 -6.62031 -18 2 15.6835 10.996 16.3292 -1.12895 -7.31017 -0.603728 -19 1 10.664 14.9341 2.30567 13.0251 3.56406 6.3158 -20 2 10.7336 14.2976 3.03428 -5.34804 6.23285 -3.50086 -21 2 11.2229 15.6743 2.58509 -4.07292 -1.48419 -0.585019 -22 1 17.1728 8.23947 10.7128 -1.64499 -1.99855 0.608593 -23 2 16.6728 8.84067 11.2819 0.316783 0.889357 -0.63917 -24 2 17.9322 8.74349 10.3965 1.71935 0.329185 -1.07247 -25 1 14.697 15.9473 16.4368 -13.7705 -0.197196 -7.11694 -26 2 13.7879 16.279 16.3001 13.6207 -4.8592 3.02749 -27 2 14.6438 15.4158 17.2461 5.07545 7.5417 -4.99128 -28 1 12.1134 13.367 0.528093 -6.39608 9.01831 -4.72995 -29 2 11.8173 13.4954 18.2644 6.74141 -8.66363 -5.87361 -30 2 11.5587 13.987 1.01769 3.38254 -3.71164 8.60635 -31 1 9.30318 5.47999 3.94883 35.8178 1.45581 -2.5285 -32 2 8.76671 5.2044 4.67379 -16.9173 -4.15595 18.9992 -33 2 8.71572 5.58687 3.21666 -20.2172 1.55363 -14.8227 -34 1 1.70529 4.08306 11.601 -3.00308 -9.11056 -2.97947 -35 2 1.52513 4.97184 11.9147 2.37337 9.05749 0.600173 -36 2 2.22567 3.63839 12.2786 -1.82607 -0.283286 1.9059 -37 1 2.04499 6.82744 8.26893 9.18028 14.0429 7.96475 -38 2 2.5896 7.29904 8.93262 -11.3816 -6.25496 -6.31442 -39 2 1.81536 5.98181 8.67357 4.33854 0.450625 -3.71013 -40 1 5.3656 4.4774 7.93824 1.44041 9.72132 7.59831 -41 2 5.44269 3.52851 7.84762 -1.19648 -12.0175 -6.62376 -42 2 4.92598 4.83778 7.16432 -9.0894 -3.97332 -7.9273 -43 1 3.32251 2.9413 17.4443 0.538374 -34.3486 -6.77872 -44 2 3.98642 3.24962 16.8336 8.9197 7.73227 -3.39959 -45 2 3.04976 3.68399 17.9526 -12.2781 23.4468 13.5982 -46 1 7.437 5.38423 6.13063 5.01567 -0.272219 -26.6536 -47 2 7.97737 5.94965 6.66546 10.8347 10.076 12.8667 -48 2 6.99068 4.78917 6.71033 -9.3836 -11.0864 17.8628 -49 1 9.80479 7.01238 12.0379 -9.46641 4.39554 -21.4508 -50 2 10.3276 6.40912 11.4906 -4.30802 3.34771 7.14548 -51 2 9.13044 7.38666 11.4225 10.4612 -8.54147 15.485 -52 1 14.0024 3.65677 8.07153 1.90613 10.1899 13.6881 -53 2 13.9361 4.48059 7.56554 -1.4656 -7.0627 2.39316 -54 2 14.1946 3.93561 8.9889 0.417494 -3.38136 -15.0381 -55 1 4.51888 17.1453 3.95588 7.87944 -4.67708 3.20643 -56 2 5.41436 17.4585 3.90856 16.3959 1.38908 8.05638 -57 2 4.13204 17.4705 3.15493 -16.1768 7.51082 -11.5461 -58 1 16.4506 16.6012 10.3314 -28.9812 -6.12917 4.01051 -59 2 15.5905 16.5574 10.8183 20.4446 2.48532 -11.9951 -60 2 16.2667 16.1387 9.49338 0.364513 2.67256 9.91326 -61 1 1.97065 4.79938 0.260671 -8.10245 -17.5737 -13.0373 -62 2 2.41281 5.12274 1.03667 10.218 10.6244 9.40508 -63 2 1.8267 5.54768 -0.321227 -3.59337 9.6389 -0.147197 -64 1 11.5035 13.2586 16.3577 -0.713967 20.2415 12.8794 -65 2 11.0441 12.4305 16.4814 -6.19498 -9.28579 -2.23027 -66 2 12.0754 13.1484 15.6021 5.65191 -4.41955 -9.63321 -67 1 10.1276 11.0105 16.8449 -6.46201 16.5427 1.83518 -68 2 10.5556 10.1721 16.794 12.0656 -22.7421 -1.13044 -69 2 9.20289 10.8171 16.6996 -9.212 1.56961 -0.130134 -70 1 11.787 17.4505 13.4822 -3.74088 11.88 -4.97071 -71 2 12.2373 16.9277 12.8063 6.56705 3.4706 4.72845 -72 2 12.0251 18.3805 13.3063 -1.30808 -7.68873 2.97322 -73 1 6.42132 9.37259 12.2366 13.1698 8.24141 3.19081 -74 2 6.99069 9.01867 11.5406 -12.3498 -0.982732 4.41902 -75 2 7.03807 9.88277 12.7853 -8.70879 -2.27031 0.0855326 -76 1 16.2815 12.8722 2.70224 -2.02351 7.50879 0.830271 -77 2 17.1172 13.3658 2.56775 -16.1548 -5.18742 1.80773 -78 2 15.5334 13.5108 2.69253 18.3367 -6.33955 1.64103 -79 1 0.729913 12.6587 5.89268 5.90957 5.27776 3.54404 -80 2 1.01336 12.4973 4.99287 4.32656 -0.558571 -7.43154 -81 2 18.4322 12.7877 5.81211 -15.2269 -3.44557 0.704235 -82 1 5.2582 16.4249 18.4194 -10.384 10.1199 -1.35479 -83 2 5.6864 15.6785 18.0038 6.48963 -9.24773 3.62069 -84 2 5.52942 16.4885 0.694307 6.00107 -3.50652 -0.438993 -85 1 0.618748 7.72132 4.16911 -57.0293 -28.7954 36.7096 -86 2 18.6577 8.06272 3.52122 -10.6934 7.30065 -13.2418 -87 2 1.44908 7.88182 3.83946 68.942 18.8036 -26.9673 -88 1 3.13476 8.97804 6.4725 9.50813 11.9402 -13.0637 -89 2 3.74054 8.49646 7.01761 11.8689 -6.06991 10.2621 -90 2 2.28514 8.86225 6.86989 -19.244 -2.30506 4.89646 -91 1 7.29998 10.3842 16.2581 17.8205 -0.109318 -17.8263 -92 2 6.62843 10.5749 15.608 -5.58859 2.04705 -1.34953 -93 2 6.87201 10.3756 17.1052 -6.43011 -2.48695 12.6131 -94 1 11.0863 0.954938 5.00203 0.851153 5.26347 3.05665 -95 2 11.191 1.83687 4.62341 -3.02583 0.75042 -0.451702 -96 2 10.8235 0.406956 4.25776 -2.05383 -4.79736 -1.16032 -97 1 4.33613 2.85707 13.1911 1.54519 27.1095 -5.33994 -98 2 4.57692 3.1724 14.0657 0.352889 6.79614 0.336856 -99 2 4.2364 1.93118 13.308 -7.70759 -34.1778 4.58716 -100 1 8.4203 10.2079 1.80876 2.06346 -1.14808 -20.454 -101 2 8.303 10.9031 2.4489 -3.41662 7.51624 10.9075 -102 2 8.71506 9.44854 2.30018 2.97787 -12.0816 9.03727 -103 1 10.3977 1.70625 15.5267 1.73644 2.79304 1.06494 -104 2 11.3647 1.6343 15.5026 -8.09264 -2.44943 -3.11689 -105 2 10.0867 1.93234 14.6348 6.55478 -0.658466 2.12488 -106 1 2.65181 12.9273 7.85805 -0.311785 2.06689 -1.07798 -107 2 3.23228 13.5447 7.39928 3.74905 0.741997 1.40009 -108 2 1.98379 12.6968 7.20259 -0.999427 -0.794231 1.07688 -109 1 3.77953 11.641 5.00453 4.18201 7.36008 7.19136 -110 2 3.61117 10.803 5.43181 -1.00449 -4.29555 7.12479 -111 2 2.98088 11.8656 4.52857 -4.84381 -0.0516249 -5.594 -112 1 6.70671 14.4383 16.9441 -2.88793 7.65462 4.66357 -113 2 7.46032 14.9632 17.2378 1.25427 -2.15328 -4.6823 -114 2 6.29331 14.8741 16.1864 7.83964 -2.53039 -3.71142 -115 1 14.1974 14.5272 3.32557 -8.64957 0.126228 1.77541 -116 2 13.6145 15.2324 2.99689 6.18241 -4.15847 9.95625 -117 2 13.7792 14.1343 4.11346 2.7139 4.36583 -10.9531 -118 1 8.49626 18.0895 16.0579 -56.9361 5.6973 -1.31016 -119 2 8.97799 17.2887 16.1101 31.3098 -20.0295 7.70991 -120 2 8.99116 0.248943 16.0582 28.7181 13.2998 -3.6499 -121 1 4.72072 1.70195 4.90499 9.17194 -24.9679 14.1726 -122 2 3.98364 2.22531 5.16555 -23.8501 10.7625 5.04957 -123 2 5.10611 2.17516 4.19081 15.0133 13.348 -19.3674 -124 1 15.0233 12.5839 16.4881 -18.3113 17.2758 -0.569629 -125 2 14.531 13.0978 17.1312 10.6463 -2.17552 11.3526 -126 2 14.3728 12.5238 15.7796 8.99848 -7.00837 -8.88439 -127 1 15.6995 18.4783 16.8755 -18.8856 10.9503 -24.4051 -128 2 16.4938 18.4127 17.3644 26.3461 0.942046 24.9737 -129 2 15.418 17.5728 16.7613 -4.49112 -11.2036 -1.17338 -130 1 1.28835 1.23059 16.5761 -5.93248 -0.138309 0.14802 -131 2 2.13994 1.64325 16.7078 7.79309 6.58334 -0.470261 -132 2 0.740967 1.66098 17.2372 -5.253 -1.12337 3.85618 -133 1 18.1629 4.44327 15.9115 -6.79632 -1.27318 -1.28488 -134 2 18.1308 3.86521 15.1462 0.0573414 -0.0912133 -1.44422 -135 2 0.437875 4.54116 16.1499 5.78898 1.89854 1.50737 -136 1 12.2373 17.0002 16.1546 0.545523 9.79929 -13.3931 -137 2 11.4461 16.6427 16.5433 -11.0844 -6.7728 9.10484 -138 2 12.011 17.1373 15.2222 3.0182 -2.09591 3.06353 -139 1 16.0678 2.55904 18.1722 10.2246 -6.29614 14.7907 -140 2 15.8342 3.46829 18.3235 -8.81825 14.1289 4.59946 -141 2 15.8732 2.39245 17.2622 -4.4601 -2.08833 -19.809 -142 1 6.72425 13.805 10.1648 -2.60578 6.66979 -6.33116 -143 2 6.49371 13.5045 11.0525 -0.564993 -6.25943 -2.37403 -144 2 6.44263 13.1457 9.51237 3.71898 -2.3263 8.04067 -145 1 10.1796 18.3897 2.72456 -2.84724 -9.82946 6.47371 -146 2 10.454 0.395639 2.08514 4.83004 8.04726 -9.16723 -147 2 9.37175 18.0281 2.35385 -6.15379 0.681222 3.71385 -148 1 3.03584 17.7169 6.12875 -8.09623 -9.32203 -7.45056 -149 2 2.18289 17.4189 5.74043 17.1828 11.6191 3.33552 -150 2 3.689 17.6882 5.40781 -11.2408 2.0569 5.59443 -151 1 12.6056 16.8615 7.96971 24.61 3.09247 -20.49 -152 2 12.0094 16.1192 7.91607 -18.906 -3.75998 3.49802 -153 2 12.4208 17.4479 8.69718 -9.87831 1.59818 13.2946 -154 1 14.8851 15.258 8.17849 4.86996 1.69705 3.53461 -155 2 13.9994 15.6489 8.25275 11.2692 6.96129 -5.86816 -156 2 15.346 15.6481 7.40987 -12.7499 -9.2219 7.50011 -157 1 17.7579 18.2305 0.335063 13.8809 -6.66068 -7.77561 -158 2 18.5388 17.6427 0.115787 -18.9695 29.962 7.44433 -159 2 18.0215 0.522838 0.460167 3.90753 -19.2563 -2.82208 -160 1 0.789759 10.4825 1.35847 3.51968 14.2812 -7.72333 -161 2 0.0798625 9.88631 1.6077 -6.45512 -1.46576 0.207918 -162 2 0.407025 11.2033 0.810215 7.48025 -15.8311 11.8414 -163 1 1.75759 12.251 3.36651 -3.2997 0.800224 -5.24767 -164 2 1.53389 11.5715 2.69671 0.947411 14.52 5.02147 -165 2 1.90006 13.112 2.93145 -3.03991 -14.1386 -4.6936 -166 1 0.626528 17.2392 4.94747 0.535799 -10.8391 4.53682 -167 2 18.8821 18.137 4.96158 -2.27873 -17.8214 11.6149 -168 2 0.354378 16.6324 5.68648 2.97307 28.5848 -17.7586 -169 1 1.10952 0.863641 9.39152 -13.7339 -4.40866 12.9037 -170 2 1.31873 0.587529 10.3088 -1.45288 2.90017 -16.0983 -171 2 0.209028 0.525909 9.24512 10.3392 4.25606 -0.349363 -172 1 16.7392 2.34887 13.3076 6.86896 9.31967 14.159 -173 2 16.9447 2.54868 12.3949 -1.60073 1.25233 -7.99088 -174 2 16.5723 1.40956 13.3727 -4.20045 -10.3799 -4.26178 -175 1 2.67499 15.8791 12.0838 -15.6649 13.6026 18.6328 -176 2 3.08767 15.4473 12.8331 1.25238 -1.62775 -1.314 -177 2 3.09072 15.5563 11.2931 8.09534 -6.35014 -12.1736 -178 1 16.4274 15.6453 6.10859 -17.0431 -16.804 0.948824 -179 2 17.3058 15.6768 6.44562 21.0308 -4.79075 10.9 -180 2 16.4023 16.3397 5.46924 -8.03031 15.1286 -15.2988 -181 1 5.80151 5.1106 11.8034 -9.99749 12.6805 7.50019 -182 2 5.41461 5.91177 12.2246 6.41162 -14.9692 -6.22456 -183 2 5.12172 4.42339 11.8362 4.25931 3.80702 2.95737 -184 1 15.1575 4.86793 0.802761 22.7174 4.42582 -27.0135 -185 2 14.9254 4.50834 1.64009 -5.31496 -5.26411 26.4075 -186 2 14.3858 5.30472 0.469017 -12.1413 5.82456 -3.82743 -187 1 16.3769 16.3844 2.01422 -5.72057 14.22 1.10565 -188 2 15.9278 16.7493 2.80314 10.8683 -6.01604 -9.24812 -189 2 16.773 17.1531 1.56448 -5.22082 -7.76197 3.40899 -190 1 0.23965 4.83003 3.84895 -16.8427 -30.7507 -16.2196 -191 2 0.252698 5.75131 3.99923 2.34384 38.0203 4.84997 -192 2 0.859131 4.45396 4.45569 14.7994 -7.19156 9.40612 -193 1 2.95205 15.0559 15.135 12.255 2.89982 -34.0079 -194 2 2.82691 14.77 16.0276 -6.33331 -2.96333 21.8089 -195 2 2.70057 15.9867 15.0833 -9.42631 -1.00353 7.2626 -196 1 1.12786 14.6523 9.50314 0.137917 -12.6668 4.07712 -197 2 1.90226 14.1941 9.14772 -4.18616 2.58129 -2.64264 -198 2 0.826039 14.044 10.1958 0.138103 8.11094 -6.03497 -199 1 13.5191 16.5585 11.5327 7.73147 -8.17374 8.97592 -200 2 13.1298 17.2703 11.0385 -2.21772 17.726 -8.86187 -201 2 13.0359 15.7976 11.2032 2.83922 -8.38127 -1.58332 -202 1 4.66669 1.44213 0.750789 16.1276 9.43437 -4.32571 -203 2 4.14083 2.03292 0.213208 -5.20243 5.56453 -6.36037 -204 2 4.0469 0.85314 1.17877 -1.04658 -3.40534 3.74731 -205 1 1.47829 18.5621 11.858 5.51121 1.25702 19.3245 -206 2 1.35114 0.550992 12.5892 2.53269 -8.70306 -5.34898 -207 2 2.06733 17.8728 12.2103 -6.7512 4.69931 -6.32602 -208 1 11.4685 10.1386 3.99675 -31.6511 -19.8648 40.1611 -209 2 11.3534 10.4173 3.11507 -1.88937 16.5167 -32.0622 -210 2 12.3922 10.1317 4.15588 31.92 0.339396 6.83567 -211 1 8.2329 12.185 3.6562 14.6677 -4.21505 -16.0366 -212 2 9.0609 12.5679 3.94713 7.11932 4.3628 2.52934 -213 2 7.63223 12.3212 4.36927 -17.6963 1.05811 24.4992 -214 1 14.5368 4.0151 3.29112 -13.123 -7.80297 -23.8392 -215 2 15.0981 3.94713 4.04639 13.729 3.5857 20.4451 -216 2 13.7669 4.51912 3.55347 -6.0046 4.6829 5.42155 -217 1 5.65486 1.65777 7.52148 58.4475 40.9395 -13.9317 -218 2 4.99661 1.25201 7.99959 -53.8788 -37.1346 38.2946 -219 2 5.51095 1.40377 6.61889 -5.49301 1.61126 -19.8188 -220 1 17.8901 1.045 4.84749 -9.94718 -16.9222 0.488244 -221 2 18.5122 1.52388 4.30334 5.34684 7.49098 -3.2278 -222 2 17.6047 1.57034 5.59464 4.63979 8.2364 3.24002 -223 1 6.81309 9.39039 4.50819 3.0131 -8.49785 6.19054 -224 2 6.80308 9.57416 5.46384 1.81054 -3.72037 -9.62081 -225 2 7.68859 9.02244 4.29465 -5.74329 4.97879 4.89484 -226 1 2.5752 14.8387 1.99973 -14.8295 0.871449 -1.75437 -227 2 3.26878 14.7632 2.65166 10.803 -1.54702 2.65568 -228 2 2.97003 14.8559 1.12279 1.99123 -2.02101 2.0261 -229 1 17.298 12.9204 13.1492 -3.4846 16.1956 -6.51124 -230 2 16.423 13.308 13.3278 8.68723 -6.18077 0.438899 -231 2 17.8438 13.7012 12.9334 -6.61166 -12.0077 2.21466 -232 1 14.9034 10.5534 1.40093 -1.35277 29.2651 19.5565 -233 2 15.388 11.3453 1.77149 -13.4573 -26.0533 -12.1606 -234 2 13.9634 10.6773 1.62965 16.0361 -2.08776 -5.28169 -235 1 5.72986 6.65162 4.58435 -17.0557 15.5593 -6.14164 -236 2 5.84842 7.61417 4.55049 3.33824 -4.32419 -0.681988 -237 2 6.28697 6.32726 5.29234 8.09232 -2.61709 -0.816212 -238 1 7.99944 8.35521 10.3848 17.9936 -2.63811 -6.27588 -239 2 8.59251 9.07404 10.0893 -6.48701 -11.154 -5.32581 -240 2 7.88909 7.71789 9.66296 -2.42609 11.6503 -0.200638 -241 1 13.4241 18.44 5.69275 23.5538 0.0525075 -9.71433 -242 2 12.6953 0.391603 5.53139 -12.0458 3.72648 -1.32391 -243 2 13.2482 18.017 6.52624 -8.74326 -11.7295 10.7578 -244 1 0.0158155 2.64508 0.27395 14.5716 -58.678 15.8132 -245 2 17.7841 2.79898 -0.0392974 -21.1138 14.4347 -10.6776 -246 2 0.56739 3.397 0.238244 13.7063 38.8805 -4.38724 -247 1 12.8888 11.0203 9.74081 14.4921 -25.5472 6.65601 -248 2 11.9442 11.0265 9.60333 -9.9467 -3.56544 -1.05488 -249 2 13.1018 10.1085 10.0646 -8.85698 19.3484 -7.35591 -250 1 0.676749 12.1402 11.0769 -15.7222 13.4662 19.3247 -251 2 18.361 12.1632 11.2371 5.51909 -2.16069 -8.49445 -252 2 1.03381 12.419 11.9274 8.68848 0.134808 -1.80861 -253 1 5.1281 7.32638 13.4074 12.574 7.81643 0.126088 -254 2 5.56178 8.11083 13.0117 -0.574951 -12.9077 2.36295 -255 2 5.67541 7.10745 14.1812 -7.25639 3.83801 -6.5213 -256 1 1.19691 6.83481 11.9192 5.63437 23.0857 0.0567084 -257 2 0.430704 7.22717 11.4609 12.0202 -4.44614 6.83847 -258 2 1.80476 7.59103 12.1282 -18.5438 -19.7012 -5.0003 -259 1 15.5112 9.6605 12.308 7.39931 -23.3592 2.14975 -260 2 15.3284 10.5626 12.1388 -11.1565 28.2269 -10.7029 -261 2 15.46 9.608 13.2546 2.72926 -7.26454 12.4411 -262 1 16.5981 12.7055 5.55132 5.93792 -6.99565 4.13948 -263 2 16.3871 13.6216 5.72312 -3.40713 11.8574 1.85996 -264 2 16.4508 12.5854 4.61105 -1.1211 0.407027 -8.19974 -265 1 6.341 9.80883 0.0188309 -5.87145 18.2236 11.3739 -266 2 5.58583 10.3592 0.271383 3.51693 -3.70717 1.01998 -267 2 6.97723 9.90576 0.746734 -2.19026 0.0209431 -7.09875 -268 1 12.2976 6.11648 4.05009 -7.99316 6.14403 -18.1211 -269 2 12.258 6.83685 3.38221 3.50754 -15.1435 11.6411 -270 2 11.4736 5.62673 3.91242 4.22123 1.1153 4.56647 -271 1 0.341758 12.8367 0.152932 -4.41368 -4.71323 -6.18075 -272 2 -0.071293 13.3938 0.818389 4.38543 6.64898 2.3316 -273 2 18.4831 12.9746 17.9873 -4.56942 3.87447 -1.94524 -274 1 3.61813 18.6313 8.61443 0.661139 8.76689 2.03667 -275 2 3.46056 18.3752 7.69711 -0.554223 -6.30588 2.24303 -276 2 2.77043 0.354615 8.90695 5.13325 -4.08936 -2.3138 -277 1 7.42355 17.3409 4.4768 -7.56741 1.42105 -0.716546 -278 2 7.51902 18.2689 4.68925 3.30463 5.13228 6.51734 -279 2 7.58206 17.32 3.5353 -0.521854 -4.80047 -8.50069 -280 1 9.24832 17.1301 12.2139 -13.1815 7.8308 -4.22869 -281 2 9.33905 16.301 11.7591 -2.0028 -14.1862 -9.75618 -282 2 10.0447 17.2202 12.718 16.3553 3.99578 13.5609 -283 1 13.2894 13.0415 8.03267 8.35671 10.0486 -9.41069 -284 2 13.3695 12.1786 8.4589 5.84428 6.69767 4.94138 -285 2 14.1604 13.5085 8.0433 -18.6948 -10.3528 3.9365 -286 1 14.8481 2.99092 15.3927 0.856118 4.40098 19.7153 -287 2 14.1706 2.3196 15.3374 -5.14829 -8.82459 -5.54141 -288 2 15.3789 2.92995 14.603 5.00888 -0.952448 -11.2281 -289 1 9.90287 15.5907 16.9887 3.86064 7.54266 0.708681 -290 2 10.4376 14.8321 16.7196 -3.05759 -5.14225 0.11478 -291 2 9.69704 15.4836 17.9287 -2.19155 -3.5869 -5.21272 -292 1 11.3068 8.44228 16.6046 -8.18504 -5.87812 -2.49231 -293 2 10.7375 7.86962 16.0559 4.371 7.7216 8.33293 -294 2 11.2933 8.06373 17.4959 1.16379 -1.60832 -8.83864 -295 1 4.00007 18.2264 16.7774 4.24494 10.2639 17.5421 -296 2 4.56172 17.6396 17.2965 -1.57319 -6.32646 -5.9019 -297 2 3.85664 0.302165 17.4089 -1.12143 -0.586814 -11.7526 -298 1 2.2479 4.22742 8.91978 -15.7964 -0.236851 -9.315 -299 2 3.17417 4.26053 8.71033 14.3134 -0.385935 -1.23962 -300 2 2.16897 4.01078 9.84529 1.80454 -0.809508 12.1296 -301 1 9.87751 10.3883 9.74788 10.9603 -30.3507 -6.41167 -302 2 9.55849 11.2198 9.44401 -12.062 25.9436 -6.06801 -303 2 10.0779 10.4258 10.6774 1.92757 5.46095 17.7276 -304 1 9.69765 0.927205 10.8701 14.9831 -0.992619 -3.75191 -305 2 9.43595 0.039964 11.1566 -10.0783 4.56951 -4.94264 -306 2 9.12787 1.25731 10.1583 -1.53115 -8.98556 4.28196 -307 1 9.19006 15.088 10.2066 22.8811 13.4843 7.03893 -308 2 8.82905 15.9231 9.90375 -5.23887 5.212 -7.88342 -309 2 8.4517 14.4971 10.2333 -16.9878 -12.2258 -0.936878 -310 1 0.910091 9.64474 10.2618 6.35784 -25.2235 -17.0921 -311 2 0.848571 10.4636 10.7331 2.68282 16.4495 1.28733 -312 2 1.6853 9.71195 9.67503 -11.8234 -0.16557 12.5577 -313 1 17.0493 4.85425 8.1315 23.124 -12.0189 -22.071 -314 2 16.5036 5.57379 8.38464 -19.6085 19.0848 9.20549 -315 2 17.0051 4.2127 8.82658 -1.69519 -7.20825 12.6053 -316 1 14.7684 14.7087 0.123438 -2.69691 -12.5371 -11.3918 -317 2 15.061 15.3506 0.758659 10.1685 10.0196 13.4831 -318 2 13.9556 14.337 0.462955 -8.28455 -4.39651 5.72223 -319 1 3.75153 11.0481 9.53582 4.71209 -10.2499 1.98044 -320 2 3.63189 11.3357 10.4456 -0.734234 5.70871 5.17654 -321 2 3.24354 11.632 8.96907 -2.43681 8.8531 -2.47663 -322 1 11.2519 10.7463 1.5017 8.48932 -12.5201 -0.266865 -323 2 11.5908 11.5519 1.12329 1.64528 14.0457 -7.10687 -324 2 10.3311 10.688 1.26079 -12.3399 1.77059 -3.9568 -325 1 13.1496 7.17281 12.6854 5.50111 -7.8338 2.87732 -326 2 14.101 6.95885 12.7444 -10.2033 1.82309 -0.47089 -327 2 12.6663 6.34751 12.851 5.63542 3.55 -1.50526 -328 1 9.61828 1.90104 0.967862 -1.73511 6.80555 -16.7575 -329 2 8.75126 1.82608 0.511852 18.7109 -2.38487 5.6602 -330 2 10.2637 2.29933 0.349253 -13.3131 -4.11214 4.99441 -331 1 10.6435 13.4896 4.54607 -8.3754 1.2658 -1.96254 -332 2 11.4795 13.0515 4.69791 8.28938 -6.58305 0.731496 -333 2 10.5798 14.1432 5.24738 -1.32643 -0.553656 5.74704 -334 1 14.4543 1.71115 10.9546 -7.69161 -4.81009 -3.91494 -335 2 15.2136 1.28396 10.5547 4.80162 -2.13195 -1.67599 -336 2 14.6015 2.65135 10.8079 -1.60778 0.935868 6.54178 -337 1 14.5384 12.1186 11.6682 4.42158 0.0609916 50.1985 -338 2 15.3244 12.3738 11.2188 19.3883 10.0258 -22.7848 -339 2 13.838 12.0043 11.0592 -19.2299 -5.1918 -28.9193 -340 1 8.19636 5.07775 9.81895 6.92668 -2.08004 -5.22277 -341 2 7.38544 5.24812 10.3055 -3.33886 -3.05544 1.61921 -342 2 8.19204 4.12852 9.59915 -2.53054 10.0553 1.98192 -343 1 1.48663 16.8897 18.439 7.38955 -7.44055 -8.00122 -344 2 1.97341 17.2271 17.6702 -6.10601 -1.16576 3.12224 -345 2 1.43805 15.9298 18.2902 4.85843 10.0488 4.15854 -346 1 1.49392 17.3013 15.324 -13.7543 10.7593 4.06087 -347 2 1.44447 18.24 15.6259 -3.67575 -24.1287 -4.86768 -348 2 0.590882 16.9129 15.3122 14.6177 13.551 2.26757 -349 1 3.61646 5.75696 6.06482 3.05275 -16.2413 -2.75756 -350 2 3.17 6.32551 6.68313 -10.4039 6.81614 9.87761 -351 2 4.1613 6.3181 5.51248 5.12466 2.54076 -5.58469 -352 1 12.4579 9.47416 14.2028 -15.1686 39.1263 4.59508 -353 2 12.91 8.74193 13.8564 21.0065 -34.4741 -21.4004 -354 2 12.311 9.21984 15.1046 -5.21536 -3.05923 17.073 -355 1 4.05954 15.2722 6.9713 -12.2847 -13.6907 9.03639 -356 2 3.52733 16.0267 6.71946 -3.69787 8.1984 -1.38185 -357 2 4.94462 15.4979 6.70957 17.3953 3.39893 0.124931 -358 1 0.676716 8.64845 15.0435 0.0448789 -8.8726 2.29819 -359 2 0.388517 9.55355 15.1457 -0.102902 11.258 0.0552156 -360 2 1.38121 8.67263 14.3922 3.78483 -0.0353447 -4.44966 -361 1 12.9131 8.29224 10.2146 2.07907 -10.3878 2.68575 -362 2 13.6346 7.78925 9.80195 -2.79275 5.95566 3.91371 -363 2 12.8029 7.87463 11.0885 3.60602 9.09063 -7.955 -364 1 15.3505 7.77425 3.51602 -25.105 2.18251 -0.815364 -365 2 14.4666 7.51634 3.2857 -7.66712 2.41401 -31.383 -366 2 15.2516 7.5997 4.43625 29.5189 -3.75051 28.1293 -367 1 17.2908 6.71242 0.0288264 8.4359 -0.0595562 3.38218 -368 2 16.7481 6.02838 0.414195 -4.41494 -10.5616 1.77026 -369 2 16.6696 7.39667 18.4317 -9.71571 9.06541 -4.14994 -370 1 8.93558 6.94317 7.77066 11.3734 11.9101 1.30985 -371 2 9.8513 7.28708 7.82315 -13.5624 -4.9569 -0.419932 -372 2 8.83457 6.3282 8.49913 -0.351333 -9.82053 6.39411 -373 1 12.3886 0.605922 1.26733 4.3474 1.63423 -5.64369 -374 2 13.3496 0.62067 1.39833 -3.50709 5.26207 -1.10414 -375 2 12.2365 0.554465 0.317002 3.44844 -5.08055 2.164 -376 1 5.6093 15.1332 14.5298 5.50237 -6.63524 -3.85361 -377 2 4.67729 15.3131 14.6547 -7.5977 -3.56809 4.17708 -378 2 5.99198 15.9265 14.1501 5.33744 7.17763 0.920224 -379 1 3.83862 6.42399 1.72255 -0.530245 0.761181 6.81888 -380 2 3.42185 7.23588 1.41886 -3.5948 7.2146 -3.68667 -381 2 3.94102 6.55655 2.67261 0.00170673 0.796504 -2.59346 -382 1 3.90756 11.5263 12.3817 0.20855 -7.47029 -8.65749 -383 2 4.79535 11.8927 12.4625 -0.681042 -1.53834 0.918823 -384 2 3.33577 12.1179 12.8713 -4.93373 1.57702 0.731635 -385 1 5.31593 3.88159 15.8542 -0.71358 -42.6288 -12.177 -386 2 5.97198 3.22378 15.5406 -6.31298 7.40988 7.32158 -387 2 5.73536 4.71214 15.7787 14.3185 32.9857 -0.935745 -388 1 14.2562 10.2258 4.56557 -18.8652 24.4894 6.04548 -389 2 14.4389 9.92543 5.45169 -1.13053 -5.88778 11.8213 -390 2 14.6954 9.63367 3.98806 17.1426 -20.2086 -20.2139 -391 1 7.6892 17.381 9.10447 19.4711 -25.2283 0.682627 -392 2 6.86971 17.6207 9.51632 -14.1206 10.5396 4.24559 -393 2 7.90224 17.9622 8.37374 -3.5427 12.2774 -4.18627 -394 1 4.51373 14.5018 3.89084 0.522587 -13.0056 -37.966 -395 2 4.5996 15.4052 4.14706 0.258928 20.2029 10.6105 -396 2 4.49773 13.963 4.65868 1.58881 -14.8294 26.2191 -397 1 14.2556 7.39762 15.8429 -9.24001 -8.17606 -10.1746 -398 2 15.1854 7.31956 15.6389 10.3704 -1.38951 -4.38862 -399 2 14.2355 7.83779 16.6857 -0.295639 4.56275 12.5602 -400 1 3.05453 18.3862 1.94671 -28.337 -27.777 -22.0693 -401 2 2.58101 17.7651 1.32015 15.7039 17.8808 20.6311 -402 2 2.35293 0.259745 2.36363 3.01847 1.93426 2.5363 -403 1 7.98344 1.63895 4.58298 -1.95289 -5.65456 5.83277 -404 2 7.39472 2.00993 3.91227 5.60846 -0.877805 -3.34347 -405 2 8.83104 1.39808 4.18815 -5.23209 5.3786 -4.6966 -406 1 2.44155 14.16 17.683 19.8901 20.6744 -11.1998 -407 2 1.71949 13.6284 17.9614 -19.7639 -16.6874 11.6615 -408 2 3.22651 13.6749 17.9404 10.3416 -4.56611 4.09925 -409 1 0.874431 1.8172 13.9017 -2.66591 2.98819 0.0720706 -410 2 0.796895 1.67216 14.8604 0.805718 -0.9226 -9.7327 -411 2 18.6311 1.96655 13.5402 2.6832 0.103556 9.2189 -412 1 4.40474 18.7103 13.8903 -4.51489 2.73844 -3.11833 -413 2 5.26066 18.332 13.6843 10.2731 -0.629088 3.90858 -414 2 4.27285 18.5624 14.8326 -2.10334 -1.04281 2.89108 -415 1 7.22541 0.768378 18.3802 -7.41292 5.22253 -10.0414 -416 2 7.14919 0.357851 17.5011 6.06274 3.8916 10.097 -417 2 6.39657 1.25171 18.5223 1.70256 -10.1891 2.75464 -418 1 16.0038 18.3833 13.9769 4.60778 -2.90009 -16.1733 -419 2 15.0678 18.3553 13.7682 -2.12799 2.80836 4.60244 -420 2 16.1189 18.6995 14.8699 -6.8859 -1.5785 15.9997 -421 1 10.1619 4.59436 16.2508 34.7775 -10.6887 1.26028 -422 2 11.1678 4.58362 16.2281 -36.3206 4.79489 -1.20103 -423 2 9.8959 3.67942 16.0718 3.3051 4.94693 0.644026 -424 1 15.9268 17.7185 4.48585 -0.443376 -19.9814 -7.77196 -425 2 16.5546 -0.221465 4.56619 12.2284 16.6263 -2.03126 -426 2 15.0862 18.0786 4.73637 -15.899 7.019 6.15678 -427 1 6.9987 17.4508 13.864 -28.5259 -4.03497 -9.84039 -428 2 7.52153 17.7102 14.6061 10.1765 7.77338 18.9538 -429 2 7.63162 17.2858 13.1766 11.9873 -1.11294 -13.1093 -430 1 13.256 6.47431 6.57718 13.0919 -2.27803 2.33044 -431 2 14.2181 6.68617 6.52776 -23.2683 -1.75779 -6.09518 -432 2 12.9031 6.34478 5.6793 8.47748 2.51219 6.97161 -433 1 7.82324 2.30197 9.35649 6.58131 4.23212 14.3466 -434 2 7.32826 2.17284 10.185 -1.16662 2.6949 -8.43976 -435 2 7.24342 2.0875 8.62812 -8.03625 -5.88123 -5.84644 -436 1 15.1686 14.8419 13.6961 6.6084 -8.9126 -6.67367 -437 2 14.8499 15.0658 14.5674 -3.29174 5.55862 10.3748 -438 2 14.9102 15.5355 13.091 -7.311 3.85237 -1.87114 -439 1 9.39203 8.3247 3.79765 -11.0731 4.19637 -5.3616 -440 2 10.2213 8.76913 3.95172 10.5135 8.75123 3.89829 -441 2 9.56922 7.39926 3.9554 -1.92777 -9.54221 1.11885 -442 1 17.7628 13.6056 16.4368 0.454101 -14.0132 9.10192 -443 2 16.8123 13.4442 16.4542 -1.43638 -1.23592 -2.30674 -444 2 17.8812 14.4042 15.9249 -1.89469 7.90276 -3.85648 -445 1 4.90818 10.546 2.83916 0.136377 -2.73925 -10.4847 -446 2 5.60998 10.1288 3.34488 4.96678 -0.616571 0.115447 -447 2 4.51664 11.1769 3.44738 0.912314 1.46625 2.09919 -448 1 3.71104 8.38719 10.068 0.753133 0.0228827 -3.76935 -449 2 3.89927 9.29887 9.80067 -2.70003 -3.09285 3.15772 -450 2 3.67512 8.396 11.0298 -2.24059 1.87779 0.37074 -451 1 15.9565 6.94095 5.99865 -8.76526 9.77307 4.96327 -452 2 16.7516 7.41234 6.24421 7.68049 3.9133 2.85915 -453 2 16.2393 6.06165 5.75492 3.70751 -7.34759 -2.0072 -454 1 15.1339 7.14501 9.07066 -1.17949 -23.8082 27.0602 -455 2 15.8283 7.58235 9.55517 11.4438 5.0236 10.3868 -456 2 15.1116 7.57875 8.25013 -4.20744 20.1878 -38.3409 -457 1 6.25297 12.9267 12.7452 -4.72449 1.01458 -5.57239 -458 2 6.98991 12.3599 12.9819 6.62509 -1.61272 7.49964 -459 2 6.12032 13.5727 13.4468 2.47956 2.45399 3.39123 -460 1 12.1116 4.51066 13.1059 -15.4407 -10.6836 -10.9314 -461 2 12.4271 4.59486 14.0171 -10.4637 -2.65404 1.19035 -462 2 11.2547 4.00523 13.0473 26.1752 13.1928 8.83048 -463 1 11.3958 8.13336 7.91828 -4.43196 -2.05658 -14.2843 -464 2 11.9753 7.54394 7.4184 3.39578 1.92795 -0.521112 -465 2 11.8257 8.23937 8.76441 1.22007 0.905858 11.3028 -466 1 17.1296 10.8754 7.54699 -15.2323 -0.655909 3.97588 -467 2 17.811 10.2663 7.31344 17.8297 -18.4071 -0.448075 -468 2 16.9935 11.379 6.74844 -4.7697 12.6356 -6.62113 -469 1 5.29547 18.1363 10.9421 18.5805 -0.935137 -5.10578 -470 2 4.88577 17.8485 11.7431 -9.76906 -7.6723 14.1577 -471 2 4.62403 18.0611 10.2783 -13.9129 1.88822 -17.2145 -472 1 7.59234 17.5076 1.75687 4.86523 1.07577 -14.9702 -473 2 8.00304 16.7666 1.28453 -8.52174 0.253094 2.89961 -474 2 7.35564 18.1425 1.05706 3.89665 -2.44167 8.83688 -475 1 1.92302 12.8778 13.5789 2.91886 3.94981 -7.24471 -476 2 1.45818 12.4106 14.2651 -5.47786 -10.2367 6.99308 -477 2 2.33812 13.6191 14.0211 -0.459782 9.91978 4.14062 -478 1 9.50973 6.75636 14.7983 0.267759 -13.8501 3.13598 -479 2 9.76861 5.87974 15.1842 -3.78976 20.025 -16.8859 -480 2 9.67323 6.78366 13.8359 6.07296 -1.5477 12.5306 -481 1 15.3007 4.25662 10.7816 1.6835 6.93604 -0.852744 -482 2 16.2201 3.94716 10.8841 -13.758 11.9338 1.00514 -483 2 15.2044 5.07319 11.3041 5.68258 -12.2185 -1.66994 -484 1 11.2682 6.20917 0.148653 5.11845 2.03204 -0.614283 -485 2 11.4613 5.3156 18.5351 10.8417 -13.6045 -1.35957 -486 2 10.3344 6.26425 -0.02153 -13.2524 10.0913 1.35666 -487 1 -0.0515508 11.3921 15.0043 28.8186 -12.3739 35.7691 -488 2 18.1888 11.7008 14.2289 -27.1505 12.4881 -39.8426 -489 2 -0.144753 12.1488 15.5889 -3.39882 3.34168 7.51926 -490 1 7.01363 9.26741 7.30523 1.11866 9.50703 -8.15996 -491 2 6.64493 8.42979 7.58084 -4.10674 -7.85165 7.60391 -492 2 7.94964 9.11568 7.16987 5.72986 -2.82238 2.51511 -493 1 18.3266 15.3189 12.3109 1.98396 7.8422 -1.62162 -494 2 0.557814 15.686 12.1521 7.34904 -2.57966 -0.481227 -495 2 17.7488 15.821 11.7275 -2.3238 -0.409324 -3.46342 -496 1 16.5074 4.41847 5.29023 -12.2776 2.5176 -39.1335 -497 2 16.8214 4.00292 6.06235 10.453 -12.003 36.2431 -498 2 17.1989 4.29433 4.62557 3.70164 8.40848 3.22117 -499 1 17.7062 3.18115 10.7633 -10.0415 -0.498888 0.968384 -500 2 18.5829 3.451 11.0307 13.8857 -2.29821 0.377097 -501 2 17.7544 2.33603 10.3089 5.51555 -4.87272 -1.50428 -502 1 12.31 -0.0249004 10.0958 7.06597 -29.3992 -7.90418 -503 2 11.4091 0.228435 10.2265 -21.0592 11.9526 6.39906 -504 2 12.8361 0.735194 10.2786 15.1995 22.0824 4.66414 -505 1 10.3672 9.76964 12.4555 1.27225 -3.68083 -7.54967 -506 2 11.1341 9.82258 13.035 0.839453 -0.704743 2.83749 -507 2 10.2702 8.82174 12.2801 -0.554943 5.543 3.04928 -508 1 0.65465 2.77798 7.04528 -2.13863 -3.2199 7.00126 -509 2 0.891211 3.42266 7.72053 -0.0150652 2.55779 -0.825415 -510 2 0.990123 1.95336 7.40694 -1.54003 -2.33595 0.508806 -511 1 0.295674 15.3348 6.84982 -3.22172 27.5014 26.3495 -512 2 0.521244 15.1551 7.76985 -0.748412 3.60522 3.47657 -513 2 0.484365 14.5358 6.4159 11.6769 -37.1534 -21.5269 -514 1 17.0573 6.99129 15.1128 -10.0859 0.519269 -2.81001 -515 2 17.7626 7.64158 14.9811 2.36054 -7.88383 3.70046 -516 2 17.4128 6.20418 15.5441 6.5971 2.49163 -1.29874 -517 1 9.10445 12.4501 8.04005 25.0355 12.8023 20.768 -518 2 9.46092 11.7782 7.45434 -7.91968 -3.65307 -8.74082 -519 2 8.16829 12.5393 7.95206 -19.3694 -6.70788 -7.44718 -520 1 1.22811 1.76814 2.9182 -6.11732 -10.0295 -0.237983 -521 2 0.712195 2.08081 2.16479 2.12402 6.69579 0.750032 -522 2 1.58605 2.52034 3.3947 3.99278 5.86411 -0.360805 -523 1 4.10894 15.0956 9.93451 6.69744 -1.75099 -1.18621 -524 2 3.96901 15.3261 9.00671 4.91376 -1.44666 0.188494 -525 2 5.04659 14.871 10.0423 -6.23862 1.0691 -5.37016 -526 1 7.35274 2.18983 14.6875 -7.358 8.13743 -4.11606 -527 2 7.08638 1.65776 13.9297 0.32385 -1.91134 2.32143 -528 2 7.57979 3.04743 14.3014 5.83731 -4.25907 3.58957 -529 1 18.4915 14.5922 2.16266 -14.7631 20.4811 3.31696 -530 2 0.685462 15.0501 2.31645 0.801171 -7.89169 -2.84158 -531 2 17.8141 15.3012 2.20781 8.07106 -12.7893 -1.48401 -532 1 9.99475 2.73128 12.8993 -0.14498 6.34622 4.34107 -533 2 9.94968 2.10764 12.1674 -2.02697 0.25981 -1.25528 -534 2 9.23805 3.32791 12.8055 1.37719 -5.85529 0.104676 -535 1 2.96937 8.88969 13.0348 8.45161 15.4602 -1.6792 -536 2 3.19044 9.8379 12.866 -0.537566 -21.2484 3.2835 -537 2 3.7799 8.47356 13.3849 -14.589 3.50084 -4.12479 -538 1 3.21 8.56161 3.75492 -0.42537 -8.47878 -37.7314 -539 2 3.66747 9.30861 3.32521 -2.76458 -7.90594 7.43156 -540 2 3.22415 8.6869 4.6856 3.07128 8.62247 25.8231 -541 1 5.62342 7.20688 8.60781 8.60088 8.53717 -11.0276 -542 2 5.53536 6.26871 8.41561 -2.891 -1.4677 7.62716 -543 2 4.92494 7.48858 9.21156 2.86443 -6.54236 0.635755 -544 1 14.9008 1.47426 1.89198 -2.54888 27.9205 4.61998 -545 2 14.5535 2.29499 2.28075 -2.57285 -15.9361 9.92214 -546 2 15.4844 1.8547 1.23467 3.18874 -15.0862 -12.382 -547 1 8.48736 15.1158 0.783841 -1.15568 2.93173 4.22404 -548 2 9.1238 15.1934 1.5071 4.62293 -5.62872 -5.40551 -549 2 7.79285 14.5509 1.14844 -2.73481 2.50701 -2.31707 -550 1 15.539 1.37952 7.19688 19.4515 3.6409 9.83231 -551 2 14.9389 0.78101 6.7773 -13.8468 -10.3512 -10.8641 -552 2 15.0003 2.07296 7.57775 -6.55979 11.3773 -1.03994 -553 1 5.01034 12.9912 18.4705 -11.9235 -4.12885 0.570622 -554 2 5.4698 12.9987 0.669061 0.312037 0.832023 7.43214 -555 2 5.59011 13.4721 17.8825 4.88062 -0.262691 -5.03625 -556 1 15.3764 8.57785 18.0866 -6.62354 -11.676 10.0569 -557 2 15.6805 9.14973 17.3909 9.52323 10.3388 -11.2321 -558 2 15.2475 9.1488 0.206008 -1.03261 3.33477 1.75561 -559 1 12.066 3.08414 18.3349 -10.3405 10.2428 -1.58162 -560 2 12.3601 2.47993 0.38654 4.70786 -1.39849 -7.75748 -561 2 12.2507 2.72995 17.4495 4.61736 -8.1861 15.8047 -562 1 13.1968 12.6883 5.15757 -0.336282 2.96846 2.60586 -563 2 13.7743 11.9999 4.79412 -5.71366 -0.326721 6.52296 -564 2 13.1697 12.5812 6.12031 6.45904 1.498 -4.43193 -565 1 6.0986 7.21596 0.138974 -12.0498 11.3036 0.237585 -566 2 5.91833 8.16028 -0.0709607 9.65884 -21.2748 10.0237 -567 2 5.34258 6.95155 0.690129 5.85049 -3.44248 -7.26534 -568 1 17.7044 15.8891 14.9714 -7.43083 8.66678 -26.2685 -569 2 16.7907 16.1885 14.8618 6.06094 -1.91119 12.6189 -570 2 17.95 15.7638 14.036 5.46338 -3.82161 12.7361 -571 1 13.1509 0.939295 16.6327 -8.19033 8.72571 -1.54201 -572 2 14.0859 0.833936 16.7968 10.9207 -0.957234 5.29932 -573 2 12.8431 0.0418051 16.5014 -5.83506 -5.32332 -1.35137 -574 1 10.9522 14.5534 7.35938 -9.11436 -19.3925 22.6665 -575 2 10.1531 14.2304 7.85485 20.6615 9.00594 -18.4516 -576 2 11.6365 13.8859 7.56325 -5.91964 10.2955 -7.71128 -577 1 17.5919 8.49388 2.10024 -0.0322199 -9.95032 2.76416 -578 2 16.7206 8.43914 2.53345 10.0393 -1.69965 -6.58888 -579 2 17.6862 7.68098 1.5623 -5.40062 15.1321 4.16518 -580 1 12.403 7.83298 1.98454 10.1699 2.43182 8.97059 -581 2 11.823 8.58837 2.10452 -0.914469 2.41145 -5.63632 -582 2 12.0432 7.27751 1.28772 -5.41827 0.0907324 -1.12401 -583 1 12.0169 14.6214 10.4613 22.6496 -4.80377 11.9203 -584 2 12.2953 14.2566 9.62296 -0.627137 -3.48742 -6.53871 -585 2 11.0904 14.7922 10.4232 -26.4922 1.86569 -7.97999 -586 1 6.79945 6.92747 15.5042 -19.94 -13.6896 0.562857 -587 2 7.71181 6.85747 15.2524 19.187 5.43316 -2.40109 -588 2 6.75196 7.52139 16.2502 2.78602 4.81827 4.32857 -589 1 8.02489 4.54706 13.3799 -9.17747 17.7449 0.879178 -590 2 7.13549 4.71954 13.0119 14.9133 -0.721221 -4.30494 -591 2 8.45659 5.41872 13.4818 -10.582 -17.269 -1.29002 -592 1 13.3893 12.1928 14.3557 -6.07818 9.44403 7.21842 -593 2 12.9754 11.3343 14.2402 3.84433 -8.34325 -3.30791 -594 2 13.789 12.4346 13.5154 0.839467 -1.50598 -4.68274 -595 1 14.6037 9.51924 7.26293 11.3016 8.32374 8.02904 -596 2 15.4883 9.92697 7.3747 -13.533 -2.89904 3.77438 -597 2 14.03 9.85877 7.96896 6.22863 -2.20078 -8.30261 -598 1 12.724 16.8794 3.24165 4.36843 -29.0517 -11.6906 -599 2 12.9143 17.2056 4.10583 4.58985 8.72699 22.0136 -600 2 12.2764 17.5776 2.79705 -13.1015 20.2627 -13.4405 -601 1 1.027 7.08618 17.3856 17.8688 -9.35062 9.83545 -602 2 0.150845 7.20834 17.7372 -11.0357 -5.72224 6.2597 -603 2 1.04228 7.56687 16.5674 -0.430665 10.2682 -15.3686 -604 1 12.9047 4.96423 15.6783 -31.9319 9.90183 -0.420667 -605 2 13.6101 4.38571 15.8945 27.3027 -16.194 0.870052 -606 2 13.2534 5.85423 15.7473 6.89498 8.57473 1.28829 -607 1 2.36359 3.37095 5.13131 13.5367 -21.0772 -51.8355 -608 2 1.78827 3.18983 5.83511 -26.0337 -9.2034 36.1161 -609 2 2.76982 4.19309 5.31063 16.9607 33.0577 11.3338 -610 1 8.25673 11.0457 13.6214 -29.0742 18.4766 -42.051 -611 2 8.3505 10.9269 14.5387 12.3752 -9.07103 37.7912 -612 2 9.04494 10.7715 13.1556 11.3248 -9.59576 5.23465 -613 1 12.933 1.51857 13.2538 -7.42773 -10.5209 16.1392 -614 2 13.555 1.47666 12.536 9.8649 3.44918 -12.9241 -615 2 12.6435 2.43109 13.2999 -2.22529 4.34734 -4.74481 -616 1 6.5593 13.6321 2.14465 -6.91915 6.53865 -12.6846 -617 2 5.89828 13.9136 2.78341 -2.94652 3.12599 2.20918 -618 2 7.14809 13.061 2.63026 6.2374 -5.23981 3.14213 -619 1 15.8933 6.50668 12.6624 16.2584 4.45316 -6.00807 -620 2 16.3963 7.03445 12.007 -8.38894 -8.88658 12.5353 -621 2 16.4415 6.50555 13.4748 -12.028 3.27562 -10.9527 -622 1 16.7983 0.717045 9.56947 3.68169 11.9749 4.12436 -623 2 16.6133 18.4601 9.81273 2.15246 -18.3954 6.85595 -624 2 16.3759 0.833391 8.71872 -3.66349 3.7587 -11.8412 -625 1 6.14397 11.6556 8.30338 8.0817 56.4015 -2.32443 -626 2 5.40727 11.3941 8.82366 -25.1595 -10.6153 12.4164 -627 2 6.54205 10.8782 7.99323 17.2725 -41.4748 -11.5815 -628 1 2.81032 8.69956 0.356218 24.742 -6.25 8.21391 -629 2 2.27105 8.19016 18.4013 -14.5977 -1.17978 -6.66412 -630 2 2.29881 9.42159 0.72289 -11.078 1.63045 0.198871 -631 1 10.1064 10.4292 6.59515 -4.60438 -3.93729 0.830471 -632 2 10.5227 9.70923 7.07758 4.69601 -3.0134 2.20114 -633 2 10.434 10.3774 5.69507 4.10481 0.747976 -4.90006 -634 1 6.80466 15.7541 6.67201 6.06476 3.31695 -2.74514 -635 2 7.12474 16.199 7.46137 -2.48244 -3.95514 6.52968 -636 2 7.21004 16.2686 5.96286 -5.79252 -2.21211 -4.39766 -637 1 6.45958 12.986 5.74076 6.97467 7.4921 0.177054 -638 2 6.67553 13.8767 6.05203 0.11849 -2.56514 -0.0944634 -639 2 6.15828 12.5051 6.51647 -3.32664 -1.56183 1.61673 -640 1 16.774 12.5213 9.71798 -12.6143 2.89661 19.2402 -641 2 17.0082 11.8947 9.03708 5.67192 -3.35034 -8.73073 -642 2 17.3962 13.2453 9.69208 4.02202 2.48097 -6.52464 -643 1 6.17384 2.92225 2.79448 3.9775 16.0199 -22.3947 -644 2 6.54801 3.78326 2.49667 -7.94175 -14.5768 11.9424 -645 2 5.69703 2.59738 2.01124 2.48224 -4.95439 10.1002 -646 1 10.7977 3.13994 3.23713 3.9771 -4.26255 2.57443 -647 2 10.0782 3.73781 3.45741 -0.0760182 2.97522 -1.01161 -648 2 10.5069 2.61778 2.47973 -3.48459 4.35709 1.40724 -ITEM: TIMESTEP -70 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.80152 6.81783 17.9876 -13.1435 8.65537 6.0931 -2 2 7.93927 7.0215 18.3978 9.39494 -6.73756 -6.11522 -3 2 8.64173 6.15327 17.319 -1.79792 -4.8767 -3.2487 -4 1 0.159104 8.33212 6.75565 -1.75886 1.86255 -0.283403 -5 2 0.400553 7.98898 5.87058 -1.56937 3.6046 13.6337 -6 2 0.532733 7.75931 7.44677 0.588181 -1.3305 -10.9259 -7 1 8.56014 0.2064 6.86713 15.1827 -2.1442 1.30375 -8 2 9.48839 0.201881 6.58247 -8.47619 -0.963055 4.35965 -9 2 8.1657 0.891093 6.32874 -5.18544 5.82437 -2.7504 -10 1 6.48158 1.74839 11.7303 -5.73112 -6.99234 -4.49671 -11 2 5.77966 2.25139 12.1582 1.03612 1.63173 -0.79005 -12 2 6.04661 0.9684 11.3341 5.10627 10.6526 7.94811 -13 1 6.96595 5.58057 2.38836 1.68885 13.6464 8.05547 -14 2 6.50498 5.94206 3.17078 2.94101 -7.34901 -12.8293 -15 2 6.93975 6.29059 1.72807 -1.07971 -9.74986 0.444847 -16 1 16.2371 10.2379 16.1019 -30.9876 -7.62323 7.88585 -17 2 17.0175 10.5802 15.7054 20.7335 11.057 -7.58035 -18 2 15.6477 10.9912 16.2983 15.508 -10.4523 -2.02188 -19 1 10.7008 14.9379 2.28795 4.31472 -8.51672 3.50984 -20 2 10.6635 14.2367 2.95607 -1.08681 7.31624 0.965 -21 2 11.2207 15.6296 2.69467 3.48557 9.19098 3.66151 -22 1 17.1795 8.23023 10.7992 8.53416 -1.59534 -8.67541 -23 2 16.5643 8.83199 11.2261 -1.39923 4.26423 7.56567 -24 2 17.9421 8.77596 10.5426 -4.34729 -3.75626 -0.741474 -25 1 14.6688 15.978 16.4285 2.33326 -11.9168 -2.20454 -26 2 13.7825 16.2968 16.2522 -6.84331 1.16869 1.85073 -27 2 14.5784 15.3806 17.1932 6.40998 12.5602 -6.81985 -28 1 12.1084 13.347 0.550082 18.7888 -12.4001 5.31554 -29 2 11.808 13.4241 18.2861 -6.00468 7.05887 -5.4437 -30 2 11.724 14.0175 1.12482 -9.88619 2.03399 -6.75529 -31 1 9.30709 5.48775 3.90966 3.41698 -5.29876 17.2174 -32 2 8.77877 5.25688 4.68667 5.61339 2.83044 3.00189 -33 2 8.64592 5.55872 3.2299 -8.10772 2.16644 -16.0449 -34 1 1.64595 4.02425 11.592 -10.9656 22.1289 -13.9701 -35 2 1.60629 4.97108 11.8395 -0.824037 -11.4025 -3.90562 -36 2 2.20491 3.59841 12.2231 10.5337 -11.1868 16.6964 -37 1 2.06621 6.87149 8.22737 1.24172 3.77126 1.52806 -38 2 2.50304 7.30143 8.97949 -2.75541 -3.2118 -2.64013 -39 2 1.97282 5.93715 8.45613 -0.171499 4.52155 4.26063 -40 1 5.3374 4.4954 7.902 -9.99384 -2.48662 -4.40208 -41 2 5.3873 3.53885 7.92862 5.32096 -10.0353 0.506932 -42 2 4.78906 4.68538 7.13029 -0.632429 8.18831 0.496784 -43 1 3.33945 2.92164 17.4119 -9.04777 -8.0172 12.2496 -44 2 4.01569 3.37904 16.9228 10.8208 5.2633 -7.4392 -45 2 2.90871 3.59334 17.9575 0.609467 0.189965 -2.29637 -46 1 7.45919 5.40741 6.16401 6.01334 0.147035 -1.33637 -47 2 7.84933 5.9815 6.83711 3.51741 -4.84398 -5.3698 -48 2 7.00259 4.70355 6.63733 -2.11297 5.93299 1.70682 -49 1 9.81228 7.01862 12.0561 -1.06857 0.870105 -3.24483 -50 2 10.2542 6.3375 11.5392 -2.78202 1.90065 -0.0845581 -51 2 9.1292 7.39963 11.4807 2.35361 -4.5728 1.86322 -52 1 13.9947 3.68643 8.08173 -5.65395 18.5094 -17.1015 -53 2 13.7843 4.54079 7.64233 1.50666 -18.9 8.64197 -54 2 14.1479 3.8993 9.00085 4.5059 2.7709 6.99075 -55 1 4.5073 17.1442 3.93435 4.48768 -12.0008 8.39889 -56 2 5.39081 17.5321 3.92633 -2.26089 2.72179 -5.35255 -57 2 4.01543 17.3459 3.13072 5.98217 13.0117 -0.399635 -58 1 16.4079 16.585 10.4121 -12.3499 -1.91652 -12.9082 -59 2 15.5551 16.5364 10.8674 2.44262 -0.34105 -1.56006 -60 2 16.2254 16.2298 9.51738 1.66683 0.349555 15.5208 -61 1 1.97926 4.78245 0.194184 -7.72676 6.8376 3.32149 -62 2 2.28164 5.2243 0.992573 8.53964 -6.59001 3.21257 -63 2 1.76914 5.52567 18.27 -2.63275 2.53007 -9.16672 -64 1 11.4134 13.2491 16.3873 0.68902 5.27402 2.7566 -65 2 10.9787 12.3908 16.4988 0.445492 6.36744 -3.52589 -66 2 11.9797 13.161 15.6117 0.593117 -3.37138 0.847423 -67 1 10.1151 10.9818 16.8138 12.4788 0.931853 3.10073 -68 2 10.558 10.1255 16.7937 -4.12284 -0.882862 -0.541555 -69 2 9.18349 10.8105 16.7424 -13.6774 -3.43657 -1.9902 -70 1 11.7994 17.4667 13.4795 12.7765 -4.5476 -2.07039 -71 2 12.3346 16.8373 12.9682 -4.67996 5.77396 2.18605 -72 2 12.2169 18.3179 13.2967 -7.11407 5.85224 3.16387 -73 1 6.41771 9.40938 12.2612 -1.11473 -8.0868 -15.4525 -74 2 7.03744 9.07449 11.5759 -13.2083 9.2101 17.4474 -75 2 6.9295 9.8935 12.9066 11.874 3.71682 2.38348 -76 1 16.2958 12.8923 2.71536 -7.68956 9.05075 5.11912 -77 2 17.1057 13.405 2.60095 0.726983 -7.0699 -1.53932 -78 2 15.5966 13.5689 2.77432 5.93986 -8.84533 -0.161974 -79 1 0.748159 12.7086 5.88144 -10.9756 -4.32923 1.80334 -80 2 1.126 12.5118 5.01571 -4.75041 4.90571 -2.30818 -81 2 18.4243 12.6438 5.75836 11.281 1.67442 1.09101 -82 1 5.27578 16.4085 18.412 4.21131 -11.5608 4.53747 -83 2 5.56823 15.5611 18.0525 -2.79743 5.31701 -3.02359 -84 2 5.61546 16.4141 0.666595 -0.372752 7.00853 0.303479 -85 1 0.645783 7.7249 4.17395 -22.5174 -18.1833 12.2453 -86 2 0.0406635 8.03244 3.50183 -6.8254 3.26088 -7.40309 -87 2 1.47404 8.07846 3.91568 30.354 9.58108 -9.75695 -88 1 3.15689 8.99663 6.46784 -29.6014 22.5811 -11.1032 -89 2 3.73467 8.6187 7.10087 15.4493 -13.4368 20.8179 -90 2 2.24881 8.95158 6.82736 13.2955 -4.68481 -5.71698 -91 1 7.31562 10.4015 16.2316 3.59442 1.76188 5.73087 -92 2 6.55849 10.6763 15.7162 -1.33577 1.2968 -0.922241 -93 2 7.0153 10.388 17.1537 0.717273 -3.98644 -9.35278 -94 1 11.0545 0.930228 4.99952 5.57476 -3.06583 5.10436 -95 2 11.2493 1.80197 4.63341 -8.70362 -0.159614 -5.22362 -96 2 10.8601 0.352804 4.24475 -0.891787 5.80331 3.4075 -97 1 4.31226 2.88036 13.174 -5.147 13.5187 -3.07305 -98 2 4.38813 3.36721 14.0053 4.89736 -4.04185 -0.502489 -99 2 4.16611 1.96327 13.4122 -1.31506 -9.67947 3.52696 -100 1 8.44169 10.2311 1.79631 7.56357 -11.9838 -1.9735 -101 2 8.31668 10.8926 2.47474 -4.45102 7.488 6.50539 -102 2 8.68604 9.43265 2.286 -2.4935 0.872154 -3.30188 -103 1 10.3613 1.71229 15.5051 2.98347 -4.15867 -5.41234 -104 2 11.2858 1.47948 15.6006 4.17674 0.252173 3.54686 -105 2 10.224 1.77346 14.5485 -4.83776 4.02156 4.39256 -106 1 2.62824 12.9587 7.89058 0.896502 -11.3927 -2.22701 -107 2 3.24219 13.4607 7.34422 -0.123332 4.88452 0.659902 -108 2 1.95928 12.6032 7.2874 1.64097 5.4786 -0.796639 -109 1 3.80872 11.636 4.95037 -11.7682 3.18495 22.2339 -110 2 3.64598 10.9456 5.61445 0.836076 6.10931 -6.44063 -111 2 2.95096 11.8687 4.56439 8.15456 -6.07271 -3.548 -112 1 6.68955 14.4669 16.969 -3.81156 3.78561 -6.36768 -113 2 7.31157 15.1356 17.2607 6.01474 -1.04117 -0.64393 -114 2 6.3928 14.7335 16.0851 0.840242 -1.58899 4.15547 -115 1 14.2051 14.5083 3.2908 -7.03725 6.3674 -0.58292 -116 2 13.7783 15.3639 3.15563 1.95336 -1.87129 -0.261548 -117 2 13.7683 14.1355 4.06228 2.52608 -4.66484 0.961916 -118 1 8.56009 18.0702 16.0712 3.20396 -8.67406 4.91505 -119 2 9.14753 17.3445 16.2475 -6.34669 -24.466 3.58587 -120 2 9.1857 0.126611 16.1642 1.87484 33.3672 -8.78222 -121 1 4.70115 1.72624 4.89274 27.4793 -6.96303 -5.48355 -122 2 3.95894 2.26041 5.13304 -17.2548 11.1403 -0.356707 -123 2 5.27782 2.26423 4.3214 -9.62564 -3.87491 4.20048 -124 1 15.0192 12.5587 16.5123 21.7041 14.8698 31.7439 -125 2 14.5985 12.983 17.2917 0.468388 -8.58398 -21.4185 -126 2 14.4797 12.5149 15.7347 -25.1252 4.80555 -9.98379 -127 1 15.7034 18.4851 16.8595 11.2428 14.4774 5.40242 -128 2 16.3726 18.3616 17.5507 -1.30019 6.81093 -3.04699 -129 2 15.2229 17.666 16.8625 -3.30988 -17.6635 -4.60623 -130 1 1.33118 1.27529 16.6047 -9.4861 0.393225 2.74141 -131 2 2.17004 1.71925 16.7831 -4.45817 3.09534 0.768406 -132 2 0.687638 1.66877 17.2201 8.28198 -2.79213 -3.95818 -133 1 18.1871 4.40384 15.9188 -4.2246 -5.6904 -13.4727 -134 2 18.0103 3.84369 15.1415 2.73285 7.2293 11.0268 -135 2 0.486098 4.58175 15.924 0.765927 0.250404 0.0527718 -136 1 12.1931 17.0307 16.1573 -7.03075 -8.39993 15.6705 -137 2 11.4402 16.4961 16.4862 10.3932 12.5123 -4.95214 -138 2 12.1197 17.0939 15.2076 -10.1529 0.179256 -12.7611 -139 1 16.106 2.59107 18.2096 -1.1157 3.6739 1.58184 -140 2 15.8464 3.51014 18.3379 -6.23469 -2.00336 3.76026 -141 2 15.8431 2.36085 17.3192 0.233798 0.882779 -7.24243 -142 1 6.71273 13.8002 10.1277 -4.97427 -8.24119 9.58999 -143 2 6.56779 13.4217 11.0085 1.93353 6.26249 -2.22943 -144 2 6.54815 13.0587 9.53715 2.49444 0.869035 -6.59786 -145 1 10.1873 18.4315 2.70955 18.3562 4.9239 2.5593 -146 2 10.5434 0.318979 1.97838 -6.6136 -2.73616 6.22508 -147 2 9.38189 18.0459 2.39836 -17.7025 -5.54205 -6.95436 -148 1 3.04496 17.7072 6.14474 -26.0897 -13.5421 -17.7616 -149 2 2.15406 17.5302 5.73662 26.1077 6.8467 16.2169 -150 2 3.64192 17.5514 5.40101 1.03601 7.77362 4.67988 -151 1 12.6273 16.8318 7.93854 -11.3452 0.662957 5.12661 -152 2 11.8845 16.2201 7.89678 1.40738 -6.80959 -10.3945 -153 2 12.3926 17.3902 8.68441 7.00662 7.84172 2.34647 -154 1 14.8855 15.2416 8.18261 -13.4645 13.8861 12.0711 -155 2 14.0556 15.7424 8.32689 13.5062 -6.9847 -4.51651 -156 2 15.2561 15.6092 7.37576 4.4997 -5.95581 -2.20609 -157 1 17.7963 18.2323 0.313468 22.8316 -1.73762 -16.8861 -158 2 18.5551 17.7341 -0.0636659 -20.2187 -0.580139 11.9305 -159 2 18.2144 0.43747 0.484185 -10.4644 5.54896 5.21224 -160 1 0.772309 10.5133 1.37975 -10.1333 -30.1062 6.79594 -161 2 0.0813059 9.81759 1.5081 15.2254 18.695 2.54909 -162 2 0.385285 11.1613 0.797203 -0.976125 9.32481 -5.57513 -163 1 1.78018 12.2676 3.33949 2.15539 9.4235 -7.57379 -164 2 1.54035 11.6193 2.6706 -4.1225 -6.27654 2.3776 -165 2 2.05243 13.0385 2.81809 -2.70385 -1.96831 6.56166 -166 1 0.659925 17.2426 4.96586 -18.1386 9.04401 18.0738 -167 2 0.178596 18.0473 5.21064 6.21229 2.02654 -16.1731 -168 2 0.324647 16.6226 5.62628 12.0605 -8.44774 -8.6881 -169 1 1.10032 0.835558 9.36207 -6.74911 6.08386 15.0138 -170 2 1.34007 0.666464 10.2949 -2.02307 -2.81345 -10.1719 -171 2 0.1714 0.592543 9.31025 -1.22709 -3.40717 -2.54195 -172 1 16.7505 2.35163 13.3289 8.60057 15.8485 -12.5846 -173 2 16.88 2.58008 12.3859 -1.48994 0.98841 16.7513 -174 2 16.5792 1.4154 13.3346 -5.94985 -15.1034 2.43107 -175 1 2.68711 15.9094 12.0537 -2.04437 -0.129745 31.1177 -176 2 3.02052 15.4906 12.8711 -6.40464 9.26827 -14.3072 -177 2 3.17282 15.5129 11.3342 0.535683 -2.02659 -8.3952 -178 1 16.4208 15.6182 6.1352 -21.1289 -3.6799 -9.5135 -179 2 17.2955 15.5836 6.51556 8.3115 3.57969 -3.1518 -180 2 16.3537 16.3493 5.49765 5.76519 -7.13598 7.22522 -181 1 5.79664 5.13529 11.8088 -4.38676 10.3557 2.90642 -182 2 5.60006 6.00552 12.2032 -0.739769 -8.67447 -3.0914 -183 2 5.02307 4.59055 11.9941 4.66701 -2.35447 -0.0408817 -184 1 15.1607 4.87263 0.806669 16.5091 -1.57376 7.82361 -185 2 14.8955 4.71033 1.72542 2.63671 -2.24198 -6.9535 -186 2 14.4069 5.23734 0.370441 -15.2288 7.71764 -6.62645 -187 1 16.3977 16.3968 1.96949 3.68196 12.8197 -24.7966 -188 2 15.8359 16.7471 2.65913 3.23547 3.93446 11.4731 -189 2 16.7724 17.1777 1.4991 -6.44753 -16.1278 10.1249 -190 1 0.213933 4.82135 3.88253 -26.808 7.93653 -12.3623 -191 2 0.234051 5.77519 3.99531 2.75938 5.29795 -1.25016 -192 2 0.961943 4.50047 4.34745 23.7428 -13.1307 13.4767 -193 1 2.96019 15.0595 15.1256 -5.74802 5.98414 7.79678 -194 2 2.74143 14.6748 15.982 5.94976 -7.2483 0.528018 -195 2 2.64636 15.9627 15.2549 -2.4967 2.40481 -11.2251 -196 1 1.11613 14.6445 9.47707 24.3082 -3.71628 -27.1602 -197 2 1.83443 14.0608 9.11052 -24.4018 17.7336 11.9542 -198 2 0.662892 14.1245 10.1216 -3.75634 -10.5151 15.6601 -199 1 13.5123 16.5361 11.5209 14.3415 8.92342 18.194 -200 2 13.0624 17.3115 11.1648 -0.833334 -0.722864 -7.66511 -201 2 12.9752 15.7809 11.2867 -3.03575 -6.70349 -11.2125 -202 1 4.68996 1.46706 0.718872 11.9134 2.33738 12.4928 -203 2 4.09477 2.04355 0.241198 -5.36661 3.4607 -5.79099 -204 2 4.1604 0.969338 1.36347 2.85434 0.638429 -14.0321 -205 1 1.49954 18.563 11.8891 -5.50653 18.8512 6.56283 -206 2 1.44134 0.571379 12.6129 -0.0136494 -9.64138 -5.67935 -207 2 2.21117 17.97 12.1221 3.30859 -8.66659 1.78907 -208 1 11.4402 10.1273 4.0296 -14.1313 -2.26429 -1.73879 -209 2 11.5467 10.5306 3.16018 -4.20959 -0.177974 3.37558 -210 2 12.3237 10.0244 4.36159 16.2917 -0.468181 5.60308 -211 1 8.19952 12.1987 3.67367 7.5254 -0.929385 2.30686 -212 2 9.06593 12.5735 3.89529 -5.56433 -0.233543 6.4332 -213 2 7.60827 12.3201 4.43288 5.90715 0.804339 0.890554 -214 1 14.5695 4.00736 3.30806 -0.853883 -3.91237 -3.28064 -215 2 15.2428 4.12216 3.97778 4.83301 -0.192226 6.11595 -216 2 13.7947 4.43075 3.66998 -10.7695 5.18811 0.448659 -217 1 5.68852 1.65707 7.54168 28.123 23.6896 24.0894 -218 2 4.98915 1.23464 8.0079 -23.0977 -17.1785 12.6492 -219 2 5.54722 1.47278 6.63267 -9.12733 -3.0122 -32.3212 -220 1 17.8871 1.01837 4.84182 2.82015 7.71075 0.411156 -221 2 18.4334 1.54735 4.24341 -1.55475 -9.21419 -1.50179 -222 2 17.685 1.60385 5.57556 -2.0638 -1.04483 2.6292 -223 1 6.8166 9.34907 4.51783 5.09473 -9.82493 1.7662 -224 2 6.68916 9.48214 5.46541 0.845655 -0.0829088 -1.52267 -225 2 7.72677 9.02302 4.42297 -5.47106 2.64724 -1.23342 -226 1 2.52902 14.8001 2.0243 -5.93162 -1.84873 -28.2955 -227 2 3.33024 14.7833 2.53171 11.9325 -2.28831 13.4023 -228 2 2.81062 14.7362 1.08886 -6.14041 -0.158095 16.8135 -229 1 17.2862 12.9192 13.1313 -13.4327 18.0081 -1.69868 -230 2 16.3974 13.2513 13.3936 19.5241 -4.39437 -6.93828 -231 2 17.8009 13.724 12.9107 -8.95295 -13.2998 3.51907 -232 1 14.8818 10.557 1.42323 -17.5015 7.25829 9.68839 -233 2 15.2835 11.3752 1.77244 -3.15433 -10.3089 -2.91904 -234 2 13.933 10.5609 1.67153 21.0133 3.93252 -5.34474 -235 1 5.70173 6.62264 4.58284 3.01718 2.50499 1.71703 -236 2 5.75902 7.56019 4.39794 2.55817 9.91828 -0.0203224 -237 2 6.42399 6.43452 5.20085 -6.85011 -4.70646 -2.52597 -238 1 8.0341 8.36204 10.3892 10.4405 -6.77488 -14.8808 -239 2 8.6296 8.90948 9.85447 -2.74542 2.30932 7.48232 -240 2 7.64772 7.74454 9.75603 -3.95063 2.60786 3.00172 -241 1 13.4272 18.4528 5.67238 9.25795 -5.11499 9.49722 -242 2 12.7163 0.440246 5.56173 -10.019 1.98309 -6.96611 -243 2 13.1619 17.9514 6.45613 2.7128 -4.57063 -2.8 -244 1 -0.0270522 2.62208 0.316378 14.2494 -14.2567 4.73545 -245 2 17.7181 2.78355 18.7164 -19.3625 -8.86024 -5.69671 -246 2 0.361548 3.46719 0.160861 21.2807 17.6319 0.792983 -247 1 12.9304 10.9756 9.73287 -28.9199 -18.5822 3.85047 -248 2 11.9453 10.9259 9.78333 22.7984 8.3459 -7.73181 -249 2 13.1639 10.0723 9.99967 2.00349 4.19966 -2.07729 -250 1 0.632704 12.1509 11.1096 7.92792 10.2243 1.08862 -251 2 18.3238 12.1837 11.2671 1.30826 1.36738 8.17016 -252 2 1.12128 12.4175 11.9061 -11.5401 0.628467 -1.63311 -253 1 5.16172 7.34292 13.3779 5.89076 -0.786387 1.26512 -254 2 5.63913 8.13751 13.0818 -0.253704 -8.62988 -1.18816 -255 2 5.64992 7.00871 14.1461 -2.49218 7.71701 -3.25354 -256 1 1.18315 6.80996 11.9457 -21.1971 9.90527 -11.1777 -257 2 0.396163 7.2181 11.5121 19.4256 -12.5543 10.5539 -258 2 1.74685 7.55572 12.1675 3.51989 2.12142 1.71712 -259 1 15.5171 9.71047 12.3281 2.29457 -6.5479 -4.23973 -260 2 15.3017 10.6102 12.0519 -2.15799 -4.39765 10.01 -261 2 15.6816 9.70968 13.2745 -0.591496 3.33032 -0.321137 -262 1 16.5873 12.6729 5.56721 2.76163 -0.166181 -5.31991 -263 2 16.3773 13.5773 5.84608 0.225425 -0.965456 -7.72797 -264 2 16.4542 12.6253 4.60029 -0.729256 4.09093 10.083 -265 1 6.36605 9.79142 0.024922 -16.0501 18.8211 -0.426432 -266 2 5.53971 10.2677 0.213525 8.17613 -4.10964 1.60097 -267 2 6.98218 10.0336 0.714657 7.30358 2.91784 7.9977 -268 1 12.2857 6.09281 4.02237 -18.7873 -18.2554 10.8389 -269 2 12.2499 6.90248 3.51498 -0.180994 1.77121 -11.4426 -270 2 11.3769 5.71462 3.99073 18.6718 6.8659 -0.0124277 -271 1 0.371339 12.8581 0.116813 -11.2914 -0.881026 -5.3546 -272 2 18.6979 13.4634 0.798717 1.88955 0.580482 0.906428 -273 2 18.4407 13.0157 17.9982 0.051521 1.66817 1.81741 -274 1 3.57562 18.6672 8.63597 16.8652 -4.29809 -8.00937 -275 2 3.39672 18.3023 7.75382 0.438355 1.17547 6.33464 -276 2 2.72388 0.290377 8.97499 -6.05452 1.31479 -1.62581 -277 1 7.38199 17.3678 4.46374 -1.38292 15.3105 6.33947 -278 2 7.69148 18.255 4.75287 -6.89683 -17.7129 -9.79531 -279 2 7.51455 17.3077 3.50947 0.595015 4.11355 1.7546 -280 1 9.26329 17.1448 12.185 -8.64248 6.96454 5.63337 -281 2 9.31183 16.2501 11.845 1.80177 -5.78684 -3.53436 -282 2 9.93599 17.2354 12.8685 5.43729 -1.39148 -3.55242 -283 1 13.2821 13.1028 8.02698 11.8692 -15.3168 6.16039 -284 2 13.4688 12.3189 8.5813 -8.97739 12.1367 -7.14337 -285 2 14.105 13.618 8.04076 -8.38267 2.98351 0.0644509 -286 1 14.8025 2.98142 15.4294 17.4288 1.80056 -2.61073 -287 2 14.201 2.26032 15.2834 -13.2348 -7.60023 -2.35086 -288 2 15.3302 3.01554 14.6169 0.118996 0.402428 5.45631 -289 1 9.92493 15.6251 16.9821 6.00495 -5.53666 -0.13681 -290 2 10.4191 14.8506 16.6821 -3.27256 -3.64184 -5.012 -291 2 9.59076 15.3546 17.8439 -3.58917 5.2502 2.724 -292 1 11.2797 8.49868 16.6198 -1.73472 -6.52809 -3.79184 -293 2 10.75 7.88393 16.0952 -2.42874 5.03231 0.808132 -294 2 11.4092 8.05007 17.4587 2.82097 -1.86681 0.519814 -295 1 4.04678 18.2455 16.7988 -8.77416 25.1666 -6.65304 -296 2 4.65779 17.694 17.284 2.06605 -2.99109 10.2548 -297 2 3.96053 0.454509 17.276 5.60906 -19.8799 -5.16878 -298 1 2.27095 4.25175 8.91936 5.9784 -6.58712 9.82608 -299 2 3.2186 4.2524 8.72216 -4.79336 -1.38402 1.94738 -300 2 2.18112 3.96584 9.85003 1.09756 8.39619 -11.3917 -301 1 9.88624 10.3936 9.78011 6.22166 -2.86793 -13.7384 -302 2 9.62293 11.2772 9.51568 -5.75811 3.67729 -6.27375 -303 2 10.0642 10.4241 10.7104 0.548842 -0.969577 22.0405 -304 1 9.71663 0.937962 10.8586 -0.709221 -7.70358 -11.4846 -305 2 9.30987 0.134657 11.1937 5.18354 -4.14977 6.17978 -306 2 9.11908 1.1943 10.1452 4.37988 8.3302 1.85952 -307 1 9.18198 15.0956 10.1953 -4.26962 6.22766 7.58802 -308 2 8.89777 15.9846 9.95951 0.743088 2.4445 -7.53567 -309 2 8.34997 14.6032 10.2066 5.52748 -3.88041 -1.79992 -310 1 0.872205 9.70338 10.2435 26.5305 -15.7209 -40.6294 -311 2 0.885793 10.5746 10.6186 -2.04601 10.7115 5.01116 -312 2 1.5471 9.74995 9.50099 -28.1395 -6.59839 33.8889 -313 1 17.1072 4.85649 8.10795 10.9462 -15.5033 5.93553 -314 2 16.3968 5.45295 8.31142 -11.4282 10.1371 2.96807 -315 2 17.1775 4.27052 8.87929 1.82351 6.10377 -11.9311 -316 1 14.794 14.6968 0.0807509 -15.0506 -16.2211 -7.1198 -317 2 15.1293 15.3316 0.707575 7.57499 5.98458 11.2724 -318 2 13.942 14.3729 0.412504 5.92115 1.12787 4.02247 -319 1 3.8058 11.0463 9.54758 -4.72716 5.89465 -11.0149 -320 2 3.75265 11.4758 10.4012 1.08641 -1.46789 11.7249 -321 2 3.34125 11.6425 8.94232 1.4747 0.62014 0.836248 -322 1 11.3036 10.7395 1.51518 17.421 7.70001 -9.9965 -323 2 11.5572 11.5513 1.04939 0.916953 -2.49636 4.28379 -324 2 10.3663 10.6689 1.38091 -17.6315 -2.91035 -1.9437 -325 1 13.1498 7.19173 12.6392 -12.6781 -12.1868 5.62798 -326 2 14.0645 6.9093 12.7169 6.63809 2.55694 -2.55252 -327 2 12.6264 6.38473 12.8035 6.43409 8.48166 -2.8301 -328 1 9.6244 1.91603 0.948782 1.73007 4.87205 -17.2591 -329 2 8.78103 1.84907 0.47922 2.387 -4.26061 4.8929 -330 2 10.2561 2.20979 0.275304 -2.56753 1.91417 5.98087 -331 1 10.6541 13.4625 4.53479 -4.64228 5.78216 2.02785 -332 2 11.5543 13.1406 4.67483 -3.60366 -2.8444 3.58336 -333 2 10.4931 14.1115 5.23949 3.28752 -7.90473 -1.94244 -334 1 14.4847 1.66582 10.9548 -5.6847 9.24739 -2.41061 -335 2 15.2495 1.25185 10.5509 3.51804 0.734089 -1.48015 -336 2 14.6665 2.62215 10.9157 -2.44239 -9.64589 2.94827 -337 1 14.5153 12.0551 11.6598 -8.57838 4.331 1.02894 -338 2 15.2406 12.4341 11.1775 15.6624 8.75252 -5.54666 -339 2 13.8905 11.8145 10.9694 -5.00706 -1.53612 2.9308 -340 1 8.18805 5.09916 9.82303 -13.8101 6.02591 4.86356 -341 2 7.31243 5.14562 10.2589 14.5937 -0.354252 -5.27398 -342 2 8.2462 4.20505 9.47267 -0.0530366 -3.80538 1.315 -343 1 1.47125 16.9173 18.4665 17.3664 16.657 -21.1079 -344 2 1.9236 17.2269 17.6455 -9.65792 -6.20403 18.6505 -345 2 1.59593 15.9726 18.4726 0.464255 -9.97504 -1.82966 -346 1 1.48039 17.3287 15.3228 1.51401 14.0556 6.72393 -347 2 1.34693 18.2292 15.6575 8.56134 -5.76509 -0.66881 -348 2 0.596093 16.984 15.2507 -11.2139 -7.77617 -1.25224 -349 1 3.58273 5.77174 6.05172 -7.98503 -18.1926 7.56457 -350 2 3.04578 6.35459 6.60151 3.24577 3.33226 -0.333817 -351 2 4.18271 6.30655 5.53303 2.15541 4.89174 -3.71227 -352 1 12.4965 9.48476 14.2165 -0.670713 16.0192 -6.73881 -353 2 12.9556 8.76438 13.7775 2.07937 -6.9932 3.10842 -354 2 12.3436 9.22115 15.1264 1.05397 -7.72063 3.19376 -355 1 4.0654 15.2599 7.01126 14.536 -9.99762 3.77636 -356 2 3.57418 16.0458 6.77165 -4.77502 7.81332 -2.1228 -357 2 5.00035 15.4681 6.83264 -6.89866 -1.23873 3.67355 -358 1 0.723833 8.69198 15.0851 1.39297 0.947643 -5.33928 -359 2 0.438801 9.60781 15.1421 -2.06214 4.43911 1.45744 -360 2 1.38458 8.70272 14.3802 0.858615 -3.42768 2.38717 -361 1 12.8756 8.29184 10.1606 18.5084 -5.85873 3.08502 -362 2 13.7209 7.89345 9.85142 -16.8549 4.13316 8.30657 -363 2 12.7515 7.97965 11.0724 6.23426 1.04322 -7.42686 -364 1 15.3229 7.8277 3.50947 17.5558 22.7432 -34.5468 -365 2 14.4697 7.71438 3.07339 -7.31906 -8.87793 15.8657 -366 2 15.4806 7.65388 4.43399 -18.8005 -15.0751 11.2523 -367 1 17.2596 6.73529 0.0260639 -2.34928 8.60384 0.474092 -368 2 16.7705 6.01921 0.434638 -6.55856 -4.92879 -0.567585 -369 2 16.5991 7.41683 18.4475 3.41319 -8.53114 -0.808778 -370 1 8.95463 6.95692 7.78734 -12.7059 -4.64784 9.91199 -371 2 9.87027 7.23168 7.81087 8.51327 4.71948 -0.0600656 -372 2 8.83651 6.35153 8.53608 0.68522 0.961995 -1.89804 -373 1 12.4059 0.607414 1.26231 3.62116 2.02707 -9.0712 -374 2 13.2571 1.01103 1.48145 3.02509 -6.80244 -1.55076 -375 2 12.4394 0.42011 0.312768 1.30302 -0.072107 7.45087 -376 1 5.61221 15.1181 14.5069 21.81 1.56396 -5.03583 -377 2 4.69671 15.2613 14.7447 -7.9418 2.21424 1.99916 -378 2 6.02853 15.9808 14.3125 -8.14435 -8.16553 0.0834836 -379 1 3.81616 6.42663 1.71897 -4.74342 3.6354 -4.79161 -380 2 3.34042 7.16969 1.31421 3.65203 2.80462 3.7212 -381 2 3.89499 6.64183 2.65143 -2.11765 2.44111 2.19083 -382 1 3.90516 11.4598 12.3793 9.45586 -8.94044 -12.3546 -383 2 4.79548 11.8227 12.4942 -7.15738 -0.735807 -0.876075 -384 2 3.31554 12.0782 12.7961 -9.4854 7.67777 7.65311 -385 1 5.30665 3.87758 15.8091 -6.5654 14.2288 -0.0449474 -386 2 5.99806 3.22942 15.6938 11.0923 -7.17561 -6.6845 -387 2 5.74209 4.7421 15.8325 -0.91092 -4.98763 -0.535492 -388 1 14.1952 10.2038 4.61463 -6.5923 1.74463 -22.8561 -389 2 14.2343 9.86507 5.49824 4.23866 -7.49318 19.2708 -390 2 14.5963 9.53108 4.04607 2.17028 4.66107 2.75401 -391 1 7.63145 17.3499 9.0679 -5.43123 5.71002 -0.0698024 -392 2 6.89643 17.6949 9.58041 -2.21022 -5.88459 7.45639 -393 2 7.83827 18.0718 8.46746 8.40651 -1.69566 -7.5742 -394 1 4.52514 14.4769 3.85867 5.05038 7.53463 5.39007 -395 2 4.64261 15.388 4.18066 -3.91408 -9.29834 -6.31781 -396 2 4.46355 13.9264 4.6465 1.7827 -2.93555 -2.6265 -397 1 14.2493 7.38723 15.8586 4.87219 -5.15553 -0.709446 -398 2 15.1473 7.29965 15.5014 -5.21416 1.68161 3.76194 -399 2 14.3665 7.7773 16.7353 0.544226 -0.39761 -4.2243 -400 1 3.0581 18.4144 1.95119 -22.1859 -8.41359 7.65322 -401 2 2.57832 17.7386 1.43356 3.30075 12.2585 2.4632 -402 2 2.38613 0.281938 2.45339 8.18993 -10.3808 -10.0068 -403 1 7.97435 1.63455 4.58282 23.9975 -9.20271 -17.826 -404 2 7.40194 1.94347 3.87976 -9.32013 4.13397 -1.27928 -405 2 8.80392 1.4125 4.10448 -12.4762 5.5818 15.8983 -406 1 2.4378 14.1623 17.6894 -3.94912 5.20331 -2.53114 -407 2 1.6661 13.615 17.8755 3.58117 1.8004 4.78536 -408 2 3.18519 13.6404 17.9779 13.28 -5.73443 1.82606 -409 1 0.901685 1.86492 13.8925 12.6905 0.691236 2.76957 -410 2 0.97461 1.67681 14.8348 2.02403 -0.73996 0.457614 -411 2 -0.0244921 1.99897 13.7259 -14.1961 2.08272 -4.4518 -412 1 4.37872 0.0904002 13.8777 13.1739 1.11326 -7.50903 -413 2 5.30332 18.4699 13.7308 -6.52685 1.52196 1.48666 -414 2 4.22979 18.5754 14.8098 -5.10379 -2.3914 9.04502 -415 1 7.27651 0.845893 18.3957 -16.6762 17.2151 26.568 -416 2 7.1678 0.492927 17.521 -0.448362 -6.22938 -12.6047 -417 2 6.39207 1.1517 18.718 17.8505 -10.612 -11.3067 -418 1 15.9607 18.375 13.9642 -35.6371 5.35013 -16.5011 -419 2 15.0008 18.4642 13.7578 26.2499 -2.51915 -0.30366 -420 2 16.0214 0.00880953 14.871 6.50934 -2.46523 19.0717 -421 1 10.2176 4.60873 16.2514 5.45645 -16.296 -9.2455 -422 2 11.1834 4.4434 16.3559 -20.4013 6.80033 -5.0518 -423 2 9.84346 3.80184 15.8357 11.7075 10.859 12.3241 -424 1 15.9288 17.6854 4.49702 -25.8895 1.84686 -2.2825 -425 2 16.5611 18.3979 4.49336 8.57016 10.0602 -1.14853 -426 2 15.0697 18.092 4.72548 12.7214 -6.58434 0.45321 -427 1 6.97646 17.4765 13.8835 1.51347 6.32825 6.74987 -428 2 7.46829 17.7625 14.676 -2.92413 -3.08896 -9.25103 -429 2 7.63479 17.4162 13.1781 -0.793447 -1.23312 2.0982 -430 1 13.2369 6.46193 6.55272 7.97686 -7.07829 -14.9633 -431 2 14.2045 6.47863 6.50403 -7.11621 7.88379 2.07663 -432 2 12.9571 6.40302 5.61769 -2.27464 -2.27743 14.9713 -433 1 7.84752 2.28013 9.41028 -8.73892 -0.731414 -17.5278 -434 2 7.29261 2.26329 10.1936 -2.39479 -1.12016 7.77392 -435 2 7.27021 1.99883 8.67538 7.42107 2.89864 6.55304 -436 1 15.163 14.8378 13.7075 -5.08255 6.9114 -1.94911 -437 2 14.828 14.9803 14.5966 0.517852 0.790599 5.03408 -438 2 14.8205 15.5736 13.1818 1.46712 -6.90646 -0.613497 -439 1 9.40195 8.33905 3.81803 -16.6236 -1.1153 -3.723 -440 2 10.1861 8.88666 3.81624 11.7714 1.21262 5.85608 -441 2 9.65895 7.42947 4.01423 -0.646232 2.08147 -2.76231 -442 1 17.7496 13.6056 16.4496 1.61536 7.2683 -6.30775 -443 2 16.7925 13.5164 16.4445 -3.33508 -5.74033 1.31806 -444 2 17.9176 14.3949 15.9026 -1.24178 -7.25826 8.29135 -445 1 4.89231 10.51 2.8606 23.2586 -26.6571 -20.5821 -446 2 5.63741 10.0083 3.24852 -7.78968 12.4235 -4.83768 -447 2 4.54582 11.03 3.56787 -4.03679 11.8248 12.8852 -448 1 3.69823 8.4002 10.0127 -3.60192 -11.2793 13.5005 -449 2 3.83759 9.3113 9.76164 0.279778 8.83932 -1.11316 -450 2 3.64192 8.42085 10.9836 -1.53751 -1.28356 -9.75822 -451 1 15.9467 6.92332 5.94112 11.8737 -8.24502 3.37919 -452 2 16.7476 7.39494 6.19571 -0.497479 1.69122 3.51528 -453 2 16.2467 6.02535 5.70675 -5.68891 13.7396 -0.851978 -454 1 15.1658 7.18492 9.0507 -10.4703 -15.8706 0.47552 -455 2 15.9236 7.59272 9.46168 11.862 8.93317 3.67812 -456 2 14.9906 7.60382 8.20629 4.02444 8.70872 -4.23998 -457 1 6.21618 12.8841 12.7284 -3.21766 12.2709 11.5322 -458 2 6.77909 12.207 13.0973 14.7659 -5.65099 1.01901 -459 2 6.15827 13.5741 13.4151 -3.2657 -3.93324 -9.28774 -460 1 12.1165 4.51288 13.1048 -1.62418 -0.0716723 20.7898 -461 2 12.3817 4.58382 14.0419 2.18295 3.85449 -11.1604 -462 2 11.2475 4.10019 13.1569 -0.321339 -3.45694 -9.73345 -463 1 11.4166 8.11249 7.92599 8.37678 -3.86112 -10.8327 -464 2 12.0468 7.60844 7.37796 -5.38848 4.21425 7.2331 -465 2 11.8428 8.18692 8.79136 -5.59584 -0.0130509 -4.24997 -466 1 17.091 10.8655 7.57222 -5.5019 -10.6926 10.9756 -467 2 17.8562 10.3128 7.37833 -2.02493 -0.998523 -7.2616 -468 2 16.8515 11.3839 6.80089 6.08197 4.8342 -8.48749 -469 1 5.2937 18.1227 10.8823 3.58086 -4.72457 -4.80722 -470 2 4.89277 17.7527 11.67 -2.28546 -3.10604 1.32943 -471 2 4.67512 17.9479 10.167 -5.31481 4.288 -3.34371 -472 1 7.59808 17.4966 1.71058 0.398559 1.64094 13.9409 -473 2 7.8828 16.705 1.25288 5.11743 -4.18927 -7.63945 -474 2 7.62118 18.2252 1.08608 -3.03358 1.0728 -8.8916 -475 1 1.91712 12.8862 13.5909 8.98798 9.32187 -3.03347 -476 2 1.48166 12.3531 14.2581 -2.09819 -2.06604 3.51643 -477 2 2.30811 13.6552 14.041 -7.16378 -5.11315 -1.13098 -478 1 9.42828 6.75322 14.7826 20.1915 -11.5504 -11.1057 -479 2 9.8277 5.94835 15.1588 -6.88663 6.02054 3.69259 -480 2 9.80073 6.79406 13.8821 -8.1098 8.28496 9.35183 -481 1 15.2968 4.25709 10.7854 2.83104 8.23395 -4.89519 -482 2 16.2313 4.08269 10.6128 -5.94582 -2.20316 7.08238 -483 2 15.3124 5.02999 11.3646 -3.5924 -3.42311 1.83328 -484 1 11.2927 6.22318 0.123361 12.5475 12.622 0.859144 -485 2 11.5233 5.29113 18.7512 -7.74436 -5.44097 -5.24926 -486 2 10.3808 6.34995 18.4806 -0.327163 -9.85792 5.03233 -487 1 18.5472 11.423 14.9732 18.3726 -20.3084 16.0571 -488 2 18.105 11.7915 14.2257 -13.2839 12.4126 -20.1368 -489 2 18.4564 12.0929 15.6514 -4.79118 8.10765 5.85542 -490 1 7.00881 9.27577 7.32015 -11.3868 -9.38104 -0.512081 -491 2 6.68278 8.41602 7.64312 1.53223 10.0212 -0.264373 -492 2 7.94615 9.16913 7.19167 13.4366 -2.83724 0.374421 -493 1 18.3388 15.3149 12.278 7.79295 4.11927 0.907342 -494 2 0.562248 15.7272 12.1255 -3.32497 -4.13752 -3.12696 -495 2 17.7171 15.7348 11.6722 2.18188 4.14775 -1.5511 -496 1 16.4968 4.40066 5.28798 -9.94208 -5.06851 -0.773295 -497 2 16.7853 4.2225 6.18546 2.9967 -3.39819 7.99443 -498 2 17.2662 4.33461 4.72457 15.1936 4.75592 -3.34352 -499 1 17.7173 3.18772 10.7866 10.4448 7.42964 -1.18609 -500 2 18.6422 3.37989 10.9855 -1.52891 3.674 4.44234 -501 2 17.7488 2.39891 10.2588 -4.04978 -15.6839 -7.32077 -502 1 12.3149 18.6145 10.0881 -2.22129 4.11252 3.54852 -503 2 11.4444 0.333084 10.2939 -3.02626 -1.86973 1.00626 -504 2 12.9201 0.705852 10.2372 4.71846 0.03299 -1.96706 -505 1 10.3684 9.76179 12.4758 17.9734 4.74974 2.50525 -506 2 11.1916 9.84607 12.9926 -11.8304 0.187235 -1.96375 -507 2 10.3012 8.81681 12.3218 -3.77483 -3.01576 0.0814472 -508 1 0.689392 2.74058 7.08104 -5.98449 10.1616 9.8561 -509 2 0.88859 3.44563 7.72485 0.581102 -9.26818 -8.93017 -510 2 0.974446 1.93578 7.5088 2.3916 -6.77547 7.05728 -511 1 0.277472 15.3259 6.84135 0.228059 -1.31559 -11.5462 -512 2 0.516029 15.5821 7.71821 6.50181 -1.47438 23.8891 -513 2 0.58839 14.4222 6.74639 0.679055 -1.95969 -5.2972 -514 1 17.0529 6.97528 15.0633 10.9144 -7.53558 1.72506 -515 2 17.8201 7.55974 14.9678 -6.11827 1.26888 -1.51964 -516 2 17.4266 6.16431 15.4413 -5.39729 2.11926 -0.659196 -517 1 9.11957 12.4732 8.03484 -32.1356 7.88594 4.6652 -518 2 9.41535 11.8783 7.35952 15.5672 -13.5118 -9.19924 -519 2 8.15954 12.512 7.86156 14.5216 4.72308 9.92056 -520 1 1.18275 1.7303 2.88012 3.13258 6.74516 -6.07855 -521 2 0.990874 2.23802 2.08159 -8.2151 -5.8717 0.0306137 -522 2 1.74436 2.31191 3.39299 4.34337 2.29394 9.11202 -523 1 4.11863 15.0886 9.98721 11.0177 -1.77256 -13.134 -524 2 4.02022 15.2012 9.03136 -3.58336 0.815549 3.23991 -525 2 5.04995 14.8741 10.1041 0.462863 -2.8957 0.615957 -526 1 7.38268 2.21023 14.7219 2.37064 11.9314 4.06902 -527 2 7.04717 1.62795 14.04 0.302375 -0.796384 -5.36483 -528 2 7.78873 2.97247 14.2654 -8.69617 -12.215 6.09363 -529 1 18.4343 14.5687 2.16054 8.35658 -0.618946 0.782777 -530 2 0.682906 14.919 2.34098 -12.2336 -1.59186 -0.620803 -531 2 17.7977 15.2902 2.22089 3.32879 4.73949 -0.959115 -532 1 10.0087 2.72001 12.9057 2.08485 -1.52945 -12.9938 -533 2 10.0412 2.17732 12.096 -1.38389 3.39971 12.264 -534 2 9.25575 3.30628 12.7713 -2.15732 -0.406341 3.704 -535 1 2.9831 8.88024 13.0189 0.952466 11.8173 -3.08609 -536 2 3.31938 9.77893 12.8076 -5.04245 -14.2298 4.61688 -537 2 3.71596 8.41411 13.4449 -4.1112 -0.429279 -5.2011 -538 1 3.20203 8.5912 3.76846 -11.4045 -12.6583 26.9753 -539 2 3.76961 9.22975 3.3591 6.50161 14.1888 -13.0281 -540 2 3.15464 8.85629 4.71231 4.40411 -9.17072 -19.7321 -541 1 5.64764 7.22249 8.60582 -2.45044 -0.628932 2.27153 -542 2 5.55364 6.27099 8.49955 3.15339 -1.29251 -2.67256 -543 2 4.90409 7.47651 9.17344 9.24373 2.45699 -1.73114 -544 1 14.907 1.53023 1.85078 -7.37767 -15.1485 8.29721 -545 2 14.668 2.24872 2.45072 11.5035 7.56218 -5.89301 -546 2 15.6059 1.77377 1.2289 -9.91057 9.46649 1.95684 -547 1 8.55561 15.0845 0.759561 -2.78586 4.97755 1.3099 -548 2 9.2232 15.1059 1.46635 -5.75771 -3.12613 -8.68727 -549 2 7.79979 14.5909 1.11068 3.03755 -1.08449 1.22088 -550 1 15.5064 1.39564 7.20176 -2.04619 -6.07348 -4.735 -551 2 14.846 0.870461 6.73047 4.3658 -0.949999 1.00211 -552 2 15.0733 2.23713 7.35024 -3.19526 7.79987 5.63196 -553 1 4.99693 12.9582 18.4618 -8.43591 -3.95032 12.7964 -554 2 5.427 12.9558 0.691187 -3.21166 1.68806 -6.66553 -555 2 5.5701 13.4759 17.8974 6.4766 -1.03013 -3.5001 -556 1 15.3823 8.61159 18.0651 4.42877 2.22092 -6.07372 -557 2 15.8154 9.23321 17.4587 -2.51695 -7.00562 1.90652 -558 2 15.1591 9.14089 0.186524 -1.03798 5.78876 7.10622 -559 1 12.0334 3.10844 18.3299 11.3082 -20.8993 7.10454 -560 2 12.3341 2.61645 0.471712 -7.66483 12.171 -5.21514 -561 2 12.3614 2.54753 17.6085 -4.58122 9.25845 0.807451 -562 1 13.192 12.7001 5.16537 5.21593 -6.7049 -2.26257 -563 2 13.6127 11.9331 4.74049 -3.39065 6.67562 5.25333 -564 2 13.2679 12.5364 6.11315 0.126366 6.17512 0.133491 -565 1 6.11282 7.21918 0.158665 1.88014 -14.5403 11.0752 -566 2 6.12514 8.17662 18.815 -2.86446 -0.617519 -0.818148 -567 2 5.41227 6.95692 0.781338 0.907384 -1.18964 -10.3034 -568 1 17.7111 15.8907 14.9544 -3.82577 1.28333 3.96962 -569 2 16.7386 15.9987 14.9233 18.3395 -0.0507343 -6.61585 -570 2 18.0408 15.7242 14.0577 -12.1828 1.42979 -0.226855 -571 1 13.1366 0.926204 16.6604 -4.9212 9.87611 -1.92759 -572 2 14.096 0.89187 16.7156 4.29984 -5.34206 5.94224 -573 2 12.8563 0.0335376 16.4436 -2.56348 -3.63873 3.02874 -574 1 10.9184 14.5253 7.38829 1.38398 -2.03118 7.00079 -575 2 10.1136 14.2278 7.85844 13.304 -1.52714 -8.95405 -576 2 11.6006 13.8396 7.51991 -9.17062 7.88742 -1.04716 -577 1 17.6363 8.46247 2.12178 -2.04395 4.31685 9.18728 -578 2 16.787 8.41765 2.58806 4.70486 1.56362 -5.63911 -579 2 17.6123 7.75928 1.47082 0.631216 -3.65047 -4.17578 -580 1 12.4375 7.79355 2.00637 -2.34281 23.5579 2.73553 -581 2 11.9501 8.63365 1.95534 8.51098 -6.49732 1.55884 -582 2 12.0343 7.24559 1.33225 -2.11395 -7.52965 -2.88654 -583 1 12.0451 14.5968 10.4885 2.58602 -10.5702 -25.2135 -584 2 12.3016 14.3716 9.56719 -0.183055 2.34539 21.1217 -585 2 11.1058 14.7694 10.4266 -10.5567 0.791778 1.58055 -586 1 6.78603 6.87835 15.4866 -3.36028 4.68136 22.1121 -587 2 7.71026 7.02894 15.2668 2.14313 -2.1467 -3.22881 -588 2 6.63472 7.41247 16.2893 -0.664868 -8.24615 -12.946 -589 1 7.99755 4.5041 13.3499 24.8278 34.1767 5.68201 -590 2 7.17338 4.66838 12.8997 -9.34484 -1.26894 -9.57598 -591 2 8.42297 5.40326 13.4231 -14.2483 -32.2403 1.51042 -592 1 13.3614 12.2059 14.3726 -2.68828 -3.01756 -2.25781 -593 2 13.124 11.2722 14.2967 -0.0467593 -0.437755 2.8377 -594 2 13.7081 12.4264 13.5024 2.10157 3.54991 -1.69903 -595 1 14.5654 9.5448 7.2719 7.4337 1.87458 1.84958 -596 2 15.4192 9.97446 7.42049 -0.421966 -1.69006 0.109976 -597 2 13.9603 9.96019 7.88547 -6.00597 1.06642 2.40823 -598 1 12.7021 16.8399 3.28406 2.1329 2.22559 -4.89416 -599 2 12.9627 17.2776 4.09814 -1.16793 0.633127 5.57798 -600 2 12.5029 17.5595 2.67417 -2.21511 -1.15635 -1.62469 -601 1 1.01088 7.06774 17.3689 20.0897 -7.47151 2.1243 -602 2 0.171968 6.83932 17.7636 -13.4375 4.7826 3.09836 -603 2 0.861358 7.69882 16.662 -3.49993 1.38105 -6.69635 -604 1 12.9265 4.90969 15.692 -1.72339 7.7777 5.20839 -605 2 13.7461 4.44088 15.8455 2.50132 -9.36464 -4.69309 -606 2 13.1831 5.83499 15.7716 0.254864 4.72294 -0.0726576 -607 1 2.3277 3.38915 5.11911 5.08689 -5.27649 -8.37414 -608 2 1.81648 3.03652 5.84872 -5.99705 -1.71944 1.12123 -609 2 2.79757 4.13118 5.49603 6.03185 12.6803 -1.33855 -610 1 8.22299 10.983 13.6596 -2.68868 6.78672 22.55 -611 2 8.37046 10.9349 14.6227 -7.71168 -0.54916 -12.6902 -612 2 9.06889 10.7219 13.2955 2.07822 -5.6604 -8.58071 -613 1 12.9566 1.54883 13.2404 -6.45532 19.0424 -4.61407 -614 2 13.4436 1.59622 12.409 4.66376 -6.5769 4.30334 -615 2 12.5511 2.44176 13.2892 3.97521 -19.3883 2.5587 -616 1 6.59697 13.6382 2.12308 -19.53 14.6785 -2.92569 -617 2 5.9569 13.9305 2.80289 7.92829 -3.31956 -9.9577 -618 2 7.23585 13.1086 2.59101 5.128 -6.56439 5.02766 -619 1 15.8657 6.47234 12.6041 4.99369 -6.06314 4.28807 -620 2 16.4551 6.98041 12.0348 -2.62867 1.80518 0.0955392 -621 2 16.3109 6.45259 13.4696 -4.62358 3.40022 -7.66147 -622 1 16.7868 0.706192 9.5524 8.10763 10.4692 12.0206 -623 2 16.4993 18.5236 9.95191 3.55616 -11.3811 -4.24312 -624 2 16.3059 0.843102 8.73445 -6.13335 -2.9453 -10.1224 -625 1 6.15553 11.6636 8.28166 8.04937 9.43191 -5.2183 -626 2 5.38812 11.3133 8.7152 -15.4132 0.789816 9.90132 -627 2 6.60546 10.8728 7.99206 7.62403 -6.5238 -2.76924 -628 1 2.80481 8.67956 0.357522 -16.6853 -5.97365 -15.2844 -629 2 2.27492 8.26466 18.2845 10.7138 4.85897 15.9492 -630 2 2.22127 9.36062 0.722932 4.52332 -2.29686 2.25001 -631 1 10.1103 10.3863 6.60128 -6.60242 -1.42487 -6.12592 -632 2 10.6136 9.70804 7.05871 2.40377 -4.05953 3.76861 -633 2 10.2954 10.2785 5.66001 4.13032 2.32994 2.59513 -634 1 6.85077 15.7563 6.70738 -11.7521 -4.07497 3.77538 -635 2 6.99262 16.2462 7.53077 3.71638 -1.24183 -4.26209 -636 2 6.92978 16.3894 5.98454 6.68147 0.141382 -0.214337 -637 1 6.48958 12.9529 5.78988 1.80967 -1.32299 -1.48619 -638 2 6.5811 13.8382 6.15183 4.24501 4.33378 1.70513 -639 2 6.11675 12.413 6.49523 0.159424 2.05888 1.44919 -640 1 16.7629 12.5191 9.71336 -1.62109 -11.3708 1.97787 -641 2 17.0324 11.8284 9.09183 -7.38478 2.50021 2.06117 -642 2 17.4395 13.1763 9.61316 3.98731 12.5093 -0.628579 -643 1 6.20997 2.89816 2.77935 -0.0802363 -5.63791 0.773513 -644 2 6.61167 3.74714 2.54082 -9.15989 -2.58724 -3.98308 -645 2 5.63039 2.60429 2.05445 8.60419 4.25286 3.07741 -646 1 10.7636 3.09526 3.23748 -2.12809 -1.19847 1.63085 -647 2 10.0581 3.70038 3.49376 4.9418 2.80865 -0.749542 -648 2 10.4122 2.60071 2.48751 -0.504171 1.44253 0.108713 -ITEM: TIMESTEP -80 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.8014 6.74321 17.9894 -25.71 0.163943 4.88408 -2 2 7.93592 6.85831 18.4426 18.3019 -2.2716 -9.29 -3 2 8.62145 6.12739 17.2721 4.06901 -0.284928 0.869098 -4 1 0.193099 8.36013 6.75275 5.74913 -14.5769 25.1987 -5 2 0.349094 8.05034 5.86501 -0.249861 0.708817 -17.2091 -6 2 0.558161 7.64099 7.32168 -7.5605 18.9357 -7.69302 -7 1 8.61156 0.29086 6.89037 18.8351 -6.84677 1.91716 -8 2 9.54524 0.192133 6.6105 -17.2936 6.40231 3.46958 -9 2 8.24205 0.986486 6.33979 -0.485036 0.67975 -2.4356 -10 1 6.46061 1.74084 11.7563 18.0716 -9.05138 -10.6926 -11 2 5.90902 2.36746 12.1907 -18.8993 15.6687 11.8916 -12 2 5.86943 1.07894 11.3852 -0.461453 -6.159 1.34784 -13 1 6.94761 5.53992 2.37529 -6.07193 26.0011 19.9509 -14 2 6.56484 5.89454 3.23997 6.76459 -12.0871 -41.8379 -15 2 6.81469 6.2225 1.67437 0.333839 -16.9501 17.8189 -16 1 16.2464 10.2212 16.095 -30.9636 -1.96085 19.7441 -17 2 16.8891 10.4896 15.4774 30.9665 9.88757 -18.0257 -18 2 15.7638 11.031 16.3423 6.62567 -11.9253 -3.68232 -19 1 10.7594 14.9468 2.28506 -10.192 -15.3258 -5.27915 -20 2 10.552 14.3194 2.98639 5.50444 -0.296801 2.35986 -21 2 11.1642 15.6696 2.7411 11.3222 17.7739 6.10774 -22 1 17.1862 8.22111 10.8759 16.4539 0.643281 -9.91552 -23 2 16.576 8.81969 11.3105 -3.64966 6.67804 4.28607 -24 2 17.949 8.77387 10.614 -8.44523 -5.92405 1.0378 -25 1 14.6358 16.0024 16.3895 25.5058 -11.0228 4.42293 -26 2 13.7352 16.2786 16.3126 -22.3429 5.97271 0.576342 -27 2 14.7081 15.5263 17.2386 -3.54281 4.69451 -12.0743 -28 1 12.1273 13.3164 0.564829 -0.361627 4.24339 0.0908299 -29 2 11.7754 13.443 18.3303 1.85705 -5.04776 -15.4247 -30 2 11.6653 13.9884 1.07404 2.42612 -1.45379 10.2607 -31 1 9.30563 5.48822 3.87958 6.5447 0.0363683 25.4904 -32 2 8.87806 5.40536 4.77034 1.54217 -0.907852 -25.4465 -33 2 8.62277 5.52424 3.19838 -5.81373 -1.17005 3.72822 -34 1 1.59219 3.96918 11.5778 -9.84269 42.1113 -23.7424 -35 2 1.65598 4.94531 11.7448 -5.32168 -23.4604 1.30407 -36 2 2.08682 3.52502 12.2368 16.8537 -14.859 24.6718 -37 1 2.0876 6.92307 8.18563 -3.73767 -8.57072 -0.0346284 -38 2 2.39381 7.30463 9.00964 5.23298 7.68032 1.6714 -39 2 2.09597 5.97338 8.35948 -3.7573 0.82597 0.238295 -40 1 5.28961 4.49122 7.85762 -5.23337 8.41869 1.15392 -41 2 5.42981 3.54006 7.92701 -4.09922 -6.37036 -7.26013 -42 2 4.64396 4.70759 7.15783 7.0556 -5.183 4.67383 -43 1 3.36027 2.89954 17.3915 -17.4395 12.4687 22.0366 -44 2 4.05476 3.43419 17.006 5.24509 0.828911 -8.29254 -45 2 2.77379 3.5226 17.8911 18.871 -11.3769 -11.5396 -46 1 7.49453 5.42535 6.18785 1.1565 -0.337813 22.5495 -47 2 7.9164 5.96716 6.90215 -9.87324 -14.4944 -23.4171 -48 2 6.89327 4.79051 6.63979 12.0833 17.318 -7.46699 -49 1 9.81909 7.02563 12.0706 7.31099 -1.858 8.99458 -50 2 10.1534 6.27284 11.5881 4.21769 -4.6772 -1.38273 -51 2 9.09614 7.33889 11.5389 -11.6555 6.63577 -10.586 -52 1 13.987 3.72336 8.09074 -16.8343 16.962 -37.2017 -53 2 13.5442 4.52839 7.7245 12.4076 -19.615 9.33911 -54 2 14.2201 3.91921 8.97962 7.00657 7.67382 26.2916 -55 1 4.5104 17.1281 3.91533 10.7578 31.6451 -21.4766 -56 2 5.3439 17.6347 3.91183 -5.56531 -14.4645 11.3324 -57 2 4.01019 17.58 3.20396 0.717673 -14.6313 13.083 -58 1 16.3456 16.5752 10.4878 9.47486 -6.83722 -28.8723 -59 2 15.5139 16.524 10.9378 -17.3385 1.90191 12.1775 -60 2 16.1667 16.1386 9.62748 3.54118 4.50203 14.5107 -61 1 1.9669 4.78352 0.127126 -0.739304 -4.30462 13.1261 -62 2 2.4124 5.1813 0.904759 -4.07407 -0.50297 -16.3737 -63 2 1.70825 5.48663 18.1668 4.40273 7.87995 3.28325 -64 1 11.3312 13.2592 16.4181 -1.15069 -16.7597 -15.9919 -65 2 10.8158 12.4247 16.4648 10.4615 17.429 3.38388 -66 2 11.9137 13.1122 15.6483 -5.75273 4.84583 10.0297 -67 1 10.0951 10.9476 16.7865 12.4257 -21.5163 1.40398 -68 2 10.4762 10.0399 16.7888 -6.98476 25.4172 2.00859 -69 2 9.15392 10.8219 16.7533 -12.5538 0.302602 -1.38706 -70 1 11.8287 17.486 13.4829 -0.118354 -13.6364 7.15806 -71 2 12.4458 16.8683 13.0504 -5.40922 13.24 -3.88075 -72 2 12.1685 18.3769 13.3708 4.2975 6.3924 -3.60834 -73 1 6.40329 9.45666 12.3007 7.59953 -15.5921 -26.3915 -74 2 7.02951 9.14458 11.6116 -13.6176 6.52201 11.0115 -75 2 6.95635 9.88774 12.9378 9.38595 10.7935 13.1394 -76 1 16.3024 12.9052 2.74142 -15.9403 -16.7132 8.77179 -77 2 17.1501 13.3041 2.5727 9.16723 7.57391 -3.15506 -78 2 15.6647 13.6204 2.85813 1.6204 2.22565 -2.39426 -79 1 0.760847 12.751 5.87222 -24.7031 -12.948 -13.3423 -80 2 1.12648 12.6956 4.9713 -1.82207 2.12621 9.26767 -81 2 18.4428 12.5289 5.74368 26.1358 12.2861 6.31515 -82 1 5.29492 16.3822 18.4146 -5.77927 -1.1636 -2.25588 -83 2 5.45161 15.4933 18.0434 4.5004 13.3336 10.181 -84 2 5.72207 16.4863 0.6292 0.349856 -6.54957 -3.00829 -85 1 0.672446 7.71977 4.17015 11.9206 5.83738 -2.65809 -86 2 0.0599114 7.99601 3.47788 2.17241 0.0211014 0.560686 -87 2 1.51354 8.18303 3.96741 -13.409 -12.9126 0.0558484 -88 1 3.18041 9.04016 6.47644 -48.733 9.26031 0.132627 -89 2 3.67612 8.69495 7.19851 13.8171 -10.3779 15.348 -90 2 2.22175 8.86945 6.71565 32.4894 5.10639 -10.1715 -91 1 7.33809 10.425 16.1982 -13.7714 -1.76245 23.4597 -92 2 6.52669 10.798 15.8343 6.52641 -1.5478 0.375626 -93 2 7.11414 10.2397 17.1395 3.58358 2.1532 -21.3577 -94 1 11.0368 0.910412 5.00755 -5.03762 -2.37072 -20.9965 -95 2 11.0166 1.76948 4.5572 3.99116 -0.122414 9.27702 -96 2 10.8085 0.318039 4.26499 2.41704 1.78329 12.9529 -97 1 4.27055 2.90822 13.1584 -5.03414 2.69466 11.7405 -98 2 4.39065 3.48249 13.9384 2.16314 -12.4788 -5.29849 -99 2 4.11656 2.00207 13.4974 4.2297 10.0998 -5.7581 -100 1 8.47529 10.248 1.79037 -0.416679 -17.2671 7.19176 -101 2 8.23967 10.8662 2.49257 2.8179 1.08296 2.51337 -102 2 8.59639 9.37915 2.23271 0.0130336 16.1865 -5.8343 -103 1 10.3383 1.70852 15.4843 -18.7352 2.46602 -2.29408 -104 2 11.1863 1.36274 15.7269 17.9639 -3.17473 -1.31836 -105 2 10.261 1.74525 14.5183 4.02029 2.26456 4.98686 -106 1 2.61381 12.97 7.91629 0.377646 -9.00714 -10.2558 -107 2 3.20736 13.521 7.38885 -1.73045 4.27865 2.80704 -108 2 1.92972 12.6563 7.30106 5.76016 2.06086 0.889789 -109 1 3.8265 11.6489 4.94253 -18.049 0.292651 15.0893 -110 2 3.64515 11.1228 5.74952 0.240622 6.04317 -17.8646 -111 2 3.00147 11.7074 4.41136 14.7829 -0.870145 11.9003 -112 1 6.67003 14.5068 16.9871 0.195301 -8.52391 -8.20479 -113 2 7.30673 15.1853 17.2075 3.81359 1.00594 1.02421 -114 2 6.51415 14.5784 16.0351 -3.74805 4.58221 3.23833 -115 1 14.2005 14.4991 3.2542 12.2104 -4.1759 -13.149 -116 2 13.9664 15.4191 3.35064 -8.52353 7.22912 -0.280994 -117 2 13.8358 14.0368 4.00136 -6.61808 -5.66537 10.7242 -118 1 8.64986 18.0488 16.0994 -35.3958 -9.60596 -0.188096 -119 2 9.08138 17.255 16.4541 14.3634 13.9351 -5.51429 -120 2 9.16615 0.19969 15.9552 18.9441 -0.541676 3.30098 -121 1 4.69447 1.75392 4.88991 25.859 26.3088 -12.7751 -122 2 3.87089 2.24691 4.93296 -3.58784 0.203107 2.94233 -123 2 5.32887 2.35869 4.40805 -22.2668 -23.8988 10.2256 -124 1 15.0337 12.5563 16.5322 -9.42235 19.0778 45.1845 -125 2 14.5415 12.8308 17.3429 25.2588 -5.91919 -13.7907 -126 2 14.3516 12.6025 15.8912 -15.7131 -4.7436 -33.7881 -127 1 15.7107 18.4933 16.8499 14.0119 15.6823 26.0515 -128 2 16.2364 18.5256 17.6977 -11.7154 -4.95338 -28.5838 -129 2 15.2517 17.6535 16.8181 2.70767 -12.4638 1.72062 -130 1 1.36288 1.31672 16.6317 -8.11361 12.6727 12.78 -131 2 2.12452 1.88684 16.8387 -7.41596 -12.3761 -6.73343 -132 2 0.666274 1.64987 17.2352 10.0682 -8.10993 -10.4284 -133 1 18.2119 4.36953 15.9172 -1.70541 -5.24792 -22.7614 -134 2 17.9042 3.81192 15.1707 6.44647 9.66147 16.3107 -135 2 0.476259 4.62247 15.7042 -5.76089 -2.38794 2.9761 -136 1 12.1484 17.0613 16.1489 -25.1744 -26.2572 32.1897 -137 2 11.4087 16.4938 16.5203 28.1495 25.8696 -8.33389 -138 2 11.9925 17.0682 15.2174 -4.06343 5.18838 -23.7308 -139 1 16.1307 2.63053 18.236 -24.4255 7.46546 -12.7341 -140 2 15.654 3.45006 18.4862 10.3096 -12.6534 -4.96798 -141 2 15.8825 2.42572 17.3162 0.942238 5.76458 9.76029 -142 1 6.69125 13.7819 10.0957 6.51523 5.30674 14.72 -143 2 6.68166 13.4115 10.9958 -3.31201 0.605957 -8.104 -144 2 6.74207 13.0463 9.48799 -5.76864 -9.77159 -4.40801 -145 1 10.1909 18.4566 2.69612 24.6552 12.5235 -11.9688 -146 2 10.5208 0.299966 1.90483 -6.63917 -6.88653 20.5003 -147 2 9.33855 18.1401 2.45819 -23.0922 -9.86885 -6.30041 -148 1 3.05041 17.6833 6.1612 -20.7399 0.346779 9.3758 -149 2 2.11766 17.6882 5.81771 32.7543 -5.44367 1.96306 -150 2 3.663 17.6288 5.4193 -6.60477 0.357372 -5.21379 -151 1 12.6301 16.8021 7.91443 2.73044 3.22351 -7.20597 -152 2 11.8394 16.2829 7.68186 3.48899 3.70212 12.2186 -153 2 12.4619 17.4281 8.63963 -10.075 -5.48551 -5.536 -154 1 14.8863 15.2402 8.20999 -23.6436 14.8183 29.3151 -155 2 14.1404 15.8836 8.27066 14.7388 -14.8318 -6.56535 -156 2 15.2763 15.3549 7.35467 9.52302 6.19548 -12.651 -157 1 17.8321 18.2493 0.273835 -34.2521 -9.59248 -4.32979 -158 2 18.5224 17.6645 -0.0392514 10.753 2.02465 3.4369 -159 2 18.2087 0.412934 0.595185 14.0613 13.0178 4.00109 -160 1 0.763956 10.5262 1.39925 -10.0074 -57.9186 33.1602 -161 2 0.0205775 9.86382 1.5781 27.9288 29.6193 -5.5527 -162 2 0.446448 11.1766 0.811593 -14.5912 25.5328 -23.4764 -163 1 1.80037 12.2889 3.30512 5.17734 11.597 19.2466 -164 2 1.46139 11.5987 2.74824 -6.10095 -9.75588 -16.5262 -165 2 2.13675 13.0044 2.75129 -3.9772 -2.70365 -1.85909 -166 1 0.682885 17.2588 4.99366 18.5034 24.5267 -32.7679 -167 2 0.107172 18.0117 5.16246 -8.54671 -5.12892 6.2039 -168 2 0.50047 16.4742 5.48014 -13.5055 -14.6224 21.6265 -169 1 1.0645 0.823506 9.34737 11.8193 5.83131 5.68962 -170 2 1.36557 0.594309 10.2448 -8.52979 0.55273 -0.975829 -171 2 0.153783 0.559257 9.28231 -13.2671 -5.76719 2.40467 -172 1 16.771 2.35127 13.3608 4.58635 29.8799 -13.6101 -173 2 16.8279 2.7166 12.4388 1.57782 -15.3367 24.752 -174 2 16.4858 1.44141 13.3191 -2.28737 -11.3359 -2.05688 -175 1 2.68433 15.9539 12.0479 2.00481 -8.12072 21.99 -176 2 2.97356 15.5639 12.9056 -4.45908 8.74231 -22.8774 -177 2 3.1524 15.4962 11.3314 -4.16555 3.83231 7.28649 -178 1 16.3902 15.5703 6.15458 18.8333 21.1033 -24.533 -179 2 17.3221 15.5371 6.43733 -15.6071 -4.56317 -0.523174 -180 2 16.3697 16.3474 5.53712 -7.15193 -24.3314 15.8574 -181 1 5.78808 5.16844 11.811 1.07675 -5.38543 -7.05048 -182 2 5.68145 6.03537 12.2081 -3.48533 4.06917 4.5041 -183 2 5.0592 4.65006 12.1655 2.16361 -4.54815 -2.94322 -184 1 15.172 4.89144 0.795633 -0.620892 -0.594882 26.39 -185 2 14.9156 4.81116 1.75201 7.19669 -4.64536 -26.7766 -186 2 14.3985 5.20255 0.336699 -8.8444 5.20324 -3.46854 -187 1 16.3986 16.4119 1.90339 15.122 14.6556 -26.5352 -188 2 16.0454 16.7612 2.71133 -6.27107 5.29423 17.303 -189 2 16.8063 17.1873 1.44657 -8.45441 -18.3773 8.08233 -190 1 0.184762 4.82044 3.92309 -20.0167 36.2337 -7.4234 -191 2 0.305381 5.80234 3.92557 1.42835 -23.0136 0.864842 -192 2 1.01251 4.4465 4.18098 17.0496 -9.16948 9.65169 -193 1 2.95853 15.072 15.1235 -0.929158 -18.0667 1.08146 -194 2 2.81752 14.526 15.9315 -1.93517 21.6459 -9.19578 -195 2 2.47159 15.9015 15.2035 -0.281788 -0.150795 8.17547 -196 1 1.08884 14.6409 9.4443 27.3966 -12.5379 -34.1186 -197 2 1.70575 13.947 9.05916 -23.9186 28.888 17.798 -198 2 0.66831 14.2301 10.1769 -7.64803 -12.9163 21.0233 -199 1 13.5173 16.5215 11.5364 0.489599 15.4909 -5.38356 -200 2 13.0836 17.2895 11.1076 8.88627 -7.75363 7.54599 -201 2 13.0704 15.7764 11.1287 -2.36322 -6.26123 2.87696 -202 1 4.73898 1.52078 0.69167 -9.68217 -10.6702 17.6377 -203 2 4.07875 2.00526 0.184075 4.46446 1.98443 -3.98397 -204 2 4.22033 0.928191 1.27988 9.48282 8.28471 -14.387 -205 1 1.52478 18.5784 11.9214 -16.2358 21.4234 -4.1613 -206 2 1.51367 0.493465 12.7143 -0.730917 -3.29007 -5.80239 -207 2 2.22048 17.951 12.0321 13.8924 -17.5303 6.45556 -208 1 11.4148 10.1041 4.08036 9.63761 14.6797 -7.17105 -209 2 11.6092 10.6619 3.28786 -9.14527 -18.7957 16.2306 -210 2 12.2661 9.96891 4.5224 -0.931524 1.73008 -8.63915 -211 1 8.18373 12.2132 3.70486 4.04638 8.18109 41.2935 -212 2 9.0456 12.58 3.98139 -6.62274 -6.35725 -9.04284 -213 2 7.64552 12.2934 4.54 8.66084 -3.68417 -28.5646 -214 1 14.5934 4.00277 3.33714 14.4882 6.32576 -0.110592 -215 2 15.3087 4.27672 3.93937 -11.245 -6.6719 -0.591331 -216 2 13.7777 4.36055 3.68688 -6.37652 3.17854 3.04506 -217 1 5.71814 1.6621 7.57513 -5.5313 -4.02265 40.0153 -218 2 5.00295 1.12677 7.97081 8.59667 7.25176 -1.51046 -219 2 5.48447 1.71188 6.6706 -7.03261 -0.519715 -37.0679 -220 1 17.8819 0.996597 4.84385 3.28334 1.22129 -8.70029 -221 2 18.3735 1.40853 4.10428 -5.78677 -2.02928 14.9184 -222 2 17.7642 1.64161 5.55539 2.20556 -0.0657175 -7.03701 -223 1 6.81886 9.28778 4.52861 6.25722 -6.76526 -10.2791 -224 2 6.61832 9.39383 5.45723 -0.00817066 1.76549 8.49843 -225 2 7.7574 9.04758 4.4954 -4.05712 -0.0763234 -2.03313 -226 1 2.4854 14.759 2.04442 -7.64745 -7.92423 -28.9185 -227 2 3.31932 14.7218 2.51092 7.63377 -1.04104 5.23896 -228 2 2.65881 14.5612 1.09422 1.17207 5.04057 23.1132 -229 1 17.2643 12.9213 13.1026 -19.9619 15.9168 2.25648 -230 2 16.3761 13.2301 13.4207 25.7036 -1.66639 -12.6722 -231 2 17.7779 13.7212 12.8621 -11.3949 -9.92691 5.05246 -232 1 14.8558 10.5579 1.44832 -24.1837 -11.6243 -0.0449549 -233 2 15.2498 11.3496 1.79784 9.85962 12.147 5.79114 -234 2 13.9164 10.5877 1.7065 14.7293 1.68269 -5.02708 -235 1 5.67033 6.62258 4.57309 8.95784 -16.3381 4.76769 -236 2 5.78141 7.53495 4.33529 5.34224 19.3995 0.612293 -237 2 6.44538 6.37316 5.11369 -12.1071 3.69782 0.132968 -238 1 8.08484 8.3464 10.3723 -2.79238 1.81559 10.704 -239 2 8.60215 8.86766 9.74634 -1.18548 0.238269 1.84293 -240 2 7.34937 7.94467 9.9053 0.580319 -4.15939 -10.1337 -241 1 13.4382 18.465 5.66883 -2.12963 -16.204 3.95429 -242 2 12.6402 0.317353 5.43723 -0.0049589 1.74147 2.86213 -243 2 13.1409 17.7635 6.28441 4.99057 13.7489 -2.35078 -244 1 -0.0389125 2.60201 0.358484 20.6019 -11.619 5.06808 -245 2 17.6744 2.57403 18.7483 8.04315 12.368 -1.45646 -246 2 0.347515 3.47455 0.194182 -8.07269 -1.54831 -1.2857 -247 1 12.9609 10.9078 9.72363 -44.1168 29.5082 -8.54535 -248 2 11.9486 10.9818 9.7709 44.2995 -10.8859 -2.13595 -249 2 13.1901 10.0051 9.91101 -8.5598 -18.2315 3.87517 -250 1 0.590645 12.1909 11.1498 11.7969 16.2942 20.6903 -251 2 18.3214 12.2032 11.4307 -13.062 -2.39731 -5.9775 -252 2 1.05781 12.4788 11.9545 1.3761 -3.96073 -11.1532 -253 1 5.19979 7.35251 13.3459 4.96104 -3.5954 0.621761 -254 2 5.77554 8.05147 13.0099 -6.36891 3.58923 -1.12306 -255 2 5.62026 7.07364 14.1664 0.643961 -0.709679 0.08133 -256 1 1.17273 6.78721 11.9743 -37.7935 -22.2758 -19.6174 -257 2 0.361865 7.16229 11.5551 20.1673 -8.51661 10.9701 -258 2 1.7013 7.51605 12.2195 19.7686 31.2325 8.39364 -259 1 15.5313 9.74152 12.3525 -7.42661 26.8763 14.1834 -260 2 15.1354 10.6339 12.1691 17.2848 -32.3992 2.44097 -261 2 15.9001 9.83422 13.2442 -4.7827 -6.0868 -10.0384 -262 1 16.5842 12.6457 5.58229 -7.58554 26.2756 -26.1768 -263 2 16.3849 13.5701 5.8413 5.71516 -14.5282 0.0223018 -264 2 16.4193 12.6729 4.60395 6.10391 -10.0799 23.5706 -265 1 6.38601 9.81704 0.0456579 -23.7849 0.890546 -8.41533 -266 2 5.51671 10.1854 0.278669 9.54818 -0.234306 -0.813632 -267 2 7.00687 10.1562 0.67255 15.5644 7.03716 17.2844 -268 1 12.2684 6.05846 4.00919 -28.2934 -33.3926 21.5663 -269 2 12.263 6.7861 3.41661 0.234348 22.4834 -18.769 -270 2 11.3224 5.76736 4.06199 25.4812 4.82389 -2.50319 -271 1 0.373791 12.8792 0.072054 -11.107 3.80906 -1.77299 -272 2 18.9015 13.5268 0.779758 -5.73011 -3.33995 1.31101 -273 2 18.3694 13.1354 18.0395 6.43374 -1.82904 2.53089 -274 1 3.55692 18.7013 8.65073 14.893 -16.0199 -12.5754 -275 2 3.38339 18.1698 7.85699 7.36237 7.58391 1.53928 -276 2 2.68044 0.23403 8.96368 -11.3363 8.83032 5.06178 -277 1 7.32525 17.3963 4.4514 17.4309 29.7426 -3.23332 -278 2 7.82401 18.2131 4.74166 -23.0386 -26.7058 -8.39786 -279 2 7.43189 17.3694 3.48275 -1.39589 -2.42936 11.5599 -280 1 9.26525 17.1572 12.169 8.13396 -3.40366 20.592 -281 2 9.29678 16.2438 11.8433 -0.925088 7.81756 -3.33389 -282 2 9.96734 17.2329 12.8546 -10.0311 -2.0771 -17.5408 -283 1 13.2786 13.1508 8.01112 -12.5044 -28.1533 13.0431 -284 2 13.4287 12.5256 8.7581 -3.83031 10.1919 -19.0767 -285 2 13.9208 13.8439 8.10408 14.3758 9.62768 2.82629 -286 1 14.7717 2.95063 15.4663 23.0059 6.37496 -12.5686 -287 2 14.1149 2.31 15.1961 -5.56432 -5.96018 -2.11564 -288 2 15.3514 3.08539 14.6861 -8.35989 -8.63193 12.4086 -289 1 9.95789 15.6422 16.9764 -4.46993 0.793564 -8.8018 -290 2 10.2307 14.8148 16.5569 1.31144 -2.42354 4.42353 -291 2 9.44172 15.4 17.7473 1.0906 -3.95706 9.45227 -292 1 11.2531 8.54113 16.6333 5.17657 0.0418295 -8.84929 -293 2 10.6325 8.00272 16.1399 -5.6117 -5.11655 -0.169214 -294 2 11.5912 7.9918 17.3372 0.751532 -6.83429 5.96975 -295 1 4.09617 18.2775 16.8038 -1.75476 28.7193 2.74196 -296 2 4.5979 17.7227 17.3968 3.26159 -10.0112 3.6984 -297 2 4.13851 0.526798 17.2077 -3.53746 -18.1625 -9.44923 -298 1 2.30039 4.26982 8.91686 21.6694 -5.11589 23.5763 -299 2 3.26852 4.19272 8.75344 -21.2665 0.643644 3.82423 -300 2 2.17319 4.0769 9.88449 2.25335 4.47185 -28.5355 -301 1 9.91449 10.4045 9.82138 -1.36818 12.3774 -23.5261 -302 2 9.54718 11.2486 9.48103 5.13969 -13.6804 7.80682 -303 2 9.93694 10.4191 10.7736 0.214264 3.33848 13.7587 -304 1 9.74784 0.927945 10.8307 17.8645 8.52415 0.395599 -305 2 9.30432 0.217271 11.2949 -5.1784 -7.81016 -3.03012 -306 2 9.13824 1.32484 10.1982 -3.45577 -3.9008 2.04599 -307 1 9.17195 15.1281 10.2005 -15.5022 -1.44929 -2.09464 -308 2 8.96814 15.9769 9.77108 -2.08214 -7.76738 2.59404 -309 2 8.35001 14.5895 10.1068 18.2617 13.451 2.66111 -310 1 0.828362 9.74081 10.2167 22.8302 -4.53826 -35.6406 -311 2 0.863435 10.6794 10.4661 0.846835 -12.3508 -3.07098 -312 2 1.42185 9.63122 9.40918 -26.8549 6.26386 38.0517 -313 1 17.1622 4.86379 8.08044 2.41554 -11.1764 16.204 -314 2 16.3163 5.29453 8.26848 4.74994 -0.845127 5.21041 -315 2 17.4172 4.31929 8.8662 -8.72341 14.5987 -22.1578 -316 1 14.8039 14.6747 0.0449816 -17.091 -7.62196 19.0468 -317 2 15.3137 15.169 0.695817 3.50252 1.08273 0.82912 -318 2 14.0068 14.3765 0.533797 12.6241 2.78049 -10.2188 -319 1 3.85026 11.0642 9.5563 -2.44831 7.24975 -16.8488 -320 2 3.90516 11.4403 10.4374 -3.64435 1.57263 7.30128 -321 2 3.45144 11.7342 8.96857 -1.60708 -4.46554 10.9787 -322 1 11.3552 10.7376 1.50363 23.7004 17.8717 -7.90317 -323 2 11.5499 11.5913 1.05012 -4.60225 -16.5984 9.56505 -324 2 10.4091 10.6312 1.49605 -14.4596 -0.264671 -3.06241 -325 1 13.1456 7.20328 12.6021 -24.9249 -2.39855 5.22786 -326 2 14.066 6.96941 12.5913 17.2615 -6.20786 -1.13088 -327 2 12.6433 6.37391 12.7221 9.22616 8.00521 -2.5813 -328 1 9.63635 1.93928 0.908954 12.9918 3.25798 9.3487 -329 2 8.80616 1.72326 0.497356 -10.689 -0.461065 -8.23177 -330 2 10.2384 2.2422 0.224542 -0.105661 1.67982 -4.44056 -331 1 10.6547 13.4406 4.52244 4.65594 3.65244 26.3326 -332 2 11.5391 13.0824 4.73514 -13.2197 2.26822 -8.08889 -333 2 10.4444 13.96 5.32492 0.722291 -5.69425 -12.9779 -334 1 14.5068 1.61853 10.9473 1.56188 14.5139 4.90111 -335 2 15.3059 1.27791 10.528 -0.453964 2.70191 1.23402 -336 2 14.6742 2.57144 11.1203 -1.66622 -13.4066 -10.2612 -337 1 14.4999 12.0198 11.6401 -20.4 4.4823 -10.6844 -338 2 15.1901 12.5044 11.1683 0.00955556 -6.20474 -4.10181 -339 2 13.88 11.6279 10.9736 17.9431 15.8984 14.8698 -340 1 8.17874 5.12415 9.82106 -30.5984 10.5693 18.9492 -341 2 7.28241 5.07355 10.2519 27.6442 5.22023 -11.9731 -342 2 8.30253 4.26697 9.4335 2.62166 -17.6444 -4.58757 -343 1 1.47714 16.9429 18.4887 13.3148 33.7663 -28.6254 -344 2 1.86682 17.2437 17.6257 -9.89818 -8.00998 25.1444 -345 2 1.74527 16.0479 18.574 6.31239 -26.8006 -0.778427 -346 1 1.45374 17.3594 15.3268 42.8952 -1.15706 -0.811193 -347 2 1.42588 18.2136 15.749 -3.30828 11.7666 5.73369 -348 2 0.584657 17.0429 15.2318 -41.4551 -8.54136 -0.705167 -349 1 3.54007 5.76039 6.04888 -8.98595 6.80975 7.90297 -350 2 3.01039 6.43039 6.5207 7.85999 -10.8756 -2.65394 -351 2 4.1622 6.27284 5.52252 1.18276 -3.83664 -2.43702 -352 1 12.5413 9.50789 14.2278 14.1386 -34.2774 -1.94842 -353 2 12.9806 8.74877 13.7665 -10.1246 23.4373 5.48687 -354 2 12.3781 9.12309 15.104 -2.49329 10.5308 -3.54938 -355 1 4.07791 15.2392 7.05947 28.2061 -4.52306 7.60827 -356 2 3.62905 16.0551 6.82 -1.6925 3.55103 -3.37365 -357 2 5.05246 15.4367 7.04645 -25.4492 -3.49557 -3.60676 -358 1 0.767125 8.74429 15.1186 -1.35051 -1.02403 -4.71838 -359 2 0.502685 9.67668 15.1423 2.70563 -3.13172 -3.80763 -360 2 1.44028 8.65803 14.4206 -5.36892 5.64782 6.7911 -361 1 12.8556 8.29114 10.1154 40.5883 -11.1151 11.7349 -362 2 13.7543 7.93714 9.90509 -23.2563 4.30646 -4.77873 -363 2 12.8036 8.10553 11.059 -7.7965 -1.57596 0.639248 -364 1 15.3061 7.91627 3.47282 -42.6646 -27.0181 14.5138 -365 2 14.4087 7.67951 3.19876 7.83283 16.2655 -25.9683 -366 2 15.288 7.37548 4.27198 30.0578 14.5578 6.00353 -367 1 17.2193 6.75387 0.0348868 -24.2654 8.60155 -9.76068 -368 2 16.7331 5.97981 0.339573 3.08011 -1.47023 2.02216 -369 2 16.4984 7.35116 18.3587 20.6605 -10.5931 7.39935 -370 1 8.96527 6.96977 7.82312 -33.6536 -16.7811 13.5927 -371 2 9.86459 7.23854 7.79988 29.8916 7.79708 0.58286 -372 2 8.85329 6.36072 8.58482 2.84704 12.8992 -8.98126 -373 1 12.4369 0.615517 1.24835 5.12967 -8.6669 -10.2958 -374 2 13.1996 1.14046 1.50868 5.63 -3.81589 5.32704 -375 2 12.6841 0.248493 0.387703 -6.12727 4.87774 5.89397 -376 1 5.63437 15.0947 14.482 15.2573 18.1506 -1.5187 -377 2 4.74012 15.1756 14.8216 -5.87791 -1.19647 -0.853033 -378 2 5.96659 16.0211 14.4028 -4.19512 -21.3346 -4.32131 -379 1 3.78146 6.44452 1.71439 -10.0957 17.3086 -10.1533 -380 2 3.36154 7.20469 1.26344 3.84289 -8.07011 2.3383 -381 2 3.80108 6.73559 2.62781 1.97525 -3.80667 6.02801 -382 1 3.89131 11.3886 12.3597 10.4858 -4.45626 -8.95185 -383 2 4.75702 11.7925 12.5217 -6.56671 -1.88331 -0.935479 -384 2 3.25208 11.9718 12.7596 -7.39976 8.19237 6.18945 -385 1 5.30831 3.87649 15.7567 -11.2019 61.1278 12.0088 -386 2 6.01892 3.27998 15.6709 29.6235 -28.0721 -9.85567 -387 2 5.7476 4.76544 15.8793 -15.8563 -28.9516 -7.19779 -388 1 14.1175 10.173 4.66017 9.40425 -19.9217 -33.2768 -389 2 14.1461 9.82294 5.54158 6.86029 -3.38102 17.8715 -390 2 14.6328 9.51646 4.11155 -16.0552 24.3993 16.1239 -391 1 7.5636 17.329 9.02789 1.81886 -5.76611 4.78707 -392 2 6.9813 17.6417 9.74433 4.383 2.36677 -11.0761 -393 2 7.91242 18.0661 8.5041 -5.60089 1.56926 3.7162 -394 1 4.54646 14.4437 3.82391 2.35855 8.70422 24.1238 -395 2 4.58695 15.3758 4.17596 -1.73775 -31.732 -9.36156 -396 2 4.50325 13.8127 4.58585 2.14298 18.0212 -18.4803 -397 1 14.2437 7.3639 15.8726 24.9361 2.31774 6.81444 -398 2 15.0991 7.30759 15.3921 -17.5628 0.546592 9.39404 -399 2 14.5002 7.74932 16.7373 -8.89015 -4.19374 -15.8798 -400 1 3.04207 18.4209 1.96748 -18.4085 17.9201 24.7102 -401 2 2.5353 17.8449 1.40649 -4.22111 -10.717 -13.4847 -402 2 2.35407 0.262093 2.48798 16.8127 -9.3976 -15.4809 -403 1 7.96924 1.62215 4.56344 31.9424 -9.467 0.421552 -404 2 7.35201 1.92948 3.90341 -1.64239 4.88827 -11.6355 -405 2 8.85795 1.52282 4.13815 -26.2226 6.52533 8.08337 -406 1 2.457 14.1626 17.6995 -18.6259 -8.83368 10.0969 -407 2 1.68725 13.6009 17.9701 23.9808 13.2635 -8.93306 -408 2 3.24279 13.6711 17.9492 9.2771 -5.34798 1.51385 -409 1 0.927142 1.91914 13.8849 28.4694 2.81528 -14.4963 -410 2 1.17928 1.66855 14.7668 -1.31862 -2.11333 16.1229 -411 2 -0.00784116 2.01924 13.8762 -26.8609 -0.0423979 -2.90492 -412 1 4.3639 0.116891 13.871 19.5154 5.98388 -10.2249 -413 2 5.3312 18.592 13.8382 -18.25 -1.84578 0.0905254 -414 2 4.09014 18.5553 14.7613 -1.68072 -4.35498 12.29 -415 1 7.32185 0.935992 18.4254 -25.1976 4.88188 40.3736 -416 2 7.29261 0.583526 17.5599 3.22929 -13.7772 -30.1977 -417 2 6.39141 0.906009 18.7671 22.6248 8.40202 -10.9225 -418 1 15.9043 18.3822 13.9598 -30.4853 6.92778 -31.02 -419 2 14.9691 18.5865 13.6701 32.1757 -7.76669 18.1984 -420 2 15.9697 -0.290473 14.9111 -4.96086 4.78357 11.6174 -421 1 10.2566 4.62301 16.2429 -20.4053 -21.3362 -19.7333 -422 2 11.1923 4.47268 16.3843 6.75918 3.74651 0.0845893 -423 2 9.94726 3.80759 15.7722 8.97755 19.5704 18.0095 -424 1 15.9188 17.665 4.49409 -30.8876 16.8748 5.69015 -425 2 16.5463 18.3904 4.38809 -0.624131 1.21894 5.03495 -426 2 15.0755 18.0798 4.84388 28.6139 -15.2662 -13.1828 -427 1 6.9464 17.5119 13.903 30.1459 16.134 14.6047 -428 2 7.45538 17.7973 14.7126 -14.438 -11.5296 -22.8133 -429 2 7.62564 17.4897 13.1926 -14.0494 -3.94126 11.1274 -430 1 13.2241 6.43487 6.53037 -11.3028 -4.49966 -3.41689 -431 2 14.1722 6.56035 6.47079 5.41657 3.67276 -3.81812 -432 2 12.8747 6.35097 5.62176 7.42053 0.356932 11.8509 -433 1 7.85865 2.26615 9.45505 -4.28533 -3.16859 -37.0089 -434 2 7.29966 2.29372 10.2234 -12.0252 -4.85104 14.2867 -435 2 7.31757 1.89726 8.71059 11.6806 10.5906 18.7024 -436 1 15.1499 14.8389 13.7285 -7.78284 7.72319 0.275575 -437 2 14.8617 14.9509 14.6481 -0.524909 3.36892 -5.65775 -438 2 14.6832 15.507 13.1912 6.48748 -10.1003 7.43034 -439 1 9.39784 8.36731 3.82962 2.5344 -9.0015 0.237957 -440 2 10.2136 8.88179 3.87227 -2.41531 -0.25237 0.330419 -441 2 9.66909 7.4454 3.98022 -9.00345 8.8328 -4.59515 -442 1 17.7291 13.5977 16.4646 5.88425 13.7422 -6.32319 -443 2 16.779 13.4368 16.4502 -3.47507 3.66531 -1.64514 -444 2 17.9175 14.4327 15.9665 -10.227 -20.4783 11.0606 -445 1 4.89529 10.4518 2.85531 35.8078 -15.8912 -9.72696 -446 2 5.76001 10.066 3.12945 -20.0856 5.21459 -7.60385 -447 2 4.65599 10.9551 3.62329 -7.19184 9.4675 7.77805 -448 1 3.68184 8.40606 9.96257 -7.06038 -13.6752 25.4145 -449 2 3.73025 9.3314 9.75201 2.05841 13.8137 -4.67922 -450 2 3.5201 8.39907 10.9276 1.35511 -1.83367 -14.7667 -451 1 15.9506 6.91676 5.90036 8.23349 -12.8437 -5.59708 -452 2 16.7283 7.39089 6.23923 -5.44721 -6.23743 -4.31526 -453 2 16.2459 6.04307 5.54881 -4.37327 20.9496 12.2757 -454 1 15.2047 7.21919 9.02648 -8.23364 16.7266 -25.0777 -455 2 16.0013 7.62239 9.37026 6.97324 -0.496136 10.989 -456 2 14.9764 7.76869 8.23928 2.79192 -13.8116 16.1423 -457 1 6.18989 12.8346 12.7303 -2.33267 17.6694 7.57139 -458 2 6.82101 12.228 13.1265 8.54383 1.14333 3.13472 -459 2 6.09938 13.6243 13.3122 2.17121 -15.6415 -7.8487 -460 1 12.1177 4.51675 13.1173 40.066 24.623 8.84127 -461 2 12.3608 4.67527 14.0558 -10.9347 -6.25445 -11.8552 -462 2 11.2865 4.0907 13.0625 -30.7168 -15.659 3.72413 -463 1 11.4382 8.09379 7.90765 11.4031 -1.65515 0.349674 -464 2 12.1555 7.64923 7.40412 -12.1024 3.57709 12.4555 -465 2 11.7306 8.14579 8.84607 -3.22191 -0.660368 -24.1915 -466 1 17.0422 10.838 7.59458 18.8696 -14.9771 -17.3127 -467 2 17.8015 10.2845 7.30277 -16.9558 5.34042 10.7777 -468 2 16.8989 11.446 6.8574 -4.66599 0.747798 1.74373 -469 1 5.2881 18.0926 10.8094 -12.0199 -6.67836 -5.57022 -470 2 4.87565 17.5902 11.533 4.52174 5.42574 -9.9319 -471 2 4.66447 18.0398 10.0548 7.40461 3.40643 11.786 -472 1 7.61349 17.4864 1.6652 -5.64906 3.24499 15.5952 -473 2 7.84327 16.7088 1.17852 12.3306 -20.6776 -4.28559 -474 2 7.74119 18.1865 1.04014 -3.89506 18.5858 -12.7246 -475 1 1.91944 12.8991 13.6003 2.94725 10.7513 13.4495 -476 2 1.49936 12.2949 14.2301 -1.35275 4.24281 -4.32331 -477 2 2.12078 13.7179 14.107 -1.08361 -15.4355 -11.6139 -478 1 9.36899 6.74386 14.7638 -2.26814 18.4847 -3.39127 -479 2 9.81478 6.02606 15.213 8.95117 -11.473 0.808352 -480 2 9.85086 6.98618 13.9577 -2.76657 -9.1339 3.81591 -481 1 15.2853 4.27459 10.7783 -6.29839 -2.79317 -1.65183 -482 2 16.2088 4.11106 10.5808 3.62417 -3.44414 3.50356 -483 2 15.3067 4.91761 11.4912 -1.69264 4.92972 1.1484 -484 1 11.3393 6.23844 0.0959214 -19.2017 -19.0623 -2.27733 -485 2 11.4465 5.27934 18.8311 9.36926 7.99257 -4.22996 -486 2 10.3892 6.29463 18.5179 14.2332 9.643 5.73673 -487 1 18.5128 11.4549 14.9487 -3.47415 -8.47336 -12.1105 -488 2 18.0135 11.8846 14.234 9.23154 -3.06455 1.62932 -489 2 18.3213 12.0172 15.6945 1.79799 8.69016 10.3557 -490 1 7.01602 9.27569 7.3226 -14.4634 -16.8581 15.1781 -491 2 6.67273 8.48369 7.80259 5.98597 16.4947 -15.5019 -492 2 7.96023 9.16216 7.29002 13.6661 -3.40194 -2.89589 -493 1 18.3593 15.3216 12.2421 14.2565 8.37053 -9.09139 -494 2 0.609114 15.6531 12.0121 -9.26774 -5.34503 6.02371 -495 2 17.7657 15.7501 11.6106 -0.96984 1.15192 3.02291 -496 1 16.5123 4.36636 5.2899 -20.1169 0.0802899 32.1896 -497 2 16.6197 4.39367 6.27015 0.689823 -6.50354 -17.1519 -498 2 17.3637 4.55338 4.93619 30.7718 -0.208347 -14.1282 -499 1 17.7452 3.18489 10.789 3.81546 21.3325 5.47337 -500 2 18.6747 3.34524 11.0396 -11.7638 -6.52287 -4.76545 -501 2 17.6832 2.38146 10.2881 5.2294 -17.628 -7.02183 -502 1 12.3161 18.6216 10.0891 7.2643 12.1904 3.38538 -503 2 11.4836 0.405415 10.3905 15.4316 -4.87983 -6.88019 -504 2 13.0526 0.636416 10.1289 -21.6037 -8.70048 2.57237 -505 1 10.3866 9.75789 12.4872 13.2725 15.9888 14.5072 -506 2 11.1625 9.86545 13.086 -15.7493 -4.39745 -10.7974 -507 2 10.2528 8.81785 12.4 2.63286 -10.7197 -2.15993 -508 1 0.710964 2.68685 7.1375 -0.1398 22.218 7.12103 -509 2 0.988905 3.47272 7.66294 -4.49485 -18.6961 -10.7978 -510 2 0.93208 1.94131 7.68754 4.63119 -8.38422 8.20051 -511 1 0.281684 15.3172 6.85959 12.828 -38.7344 -20.2135 -512 2 0.500898 15.7193 7.67574 7.5107 6.97721 30.9172 -513 2 0.662709 14.3998 6.92418 -16.2289 29.7866 -9.89698 -514 1 17.0547 6.94606 15.0133 0.165691 -3.90506 -0.393601 -515 2 17.812 7.5465 14.9118 -2.55694 -6.08978 1.76467 -516 2 17.3809 6.10212 15.3719 1.63232 8.8395 -1.4121 -517 1 9.12112 12.493 8.02809 -41.9273 18.4298 17.1595 -518 2 9.51251 11.917 7.38329 0.012751 -17.4797 -14.5944 -519 2 8.13115 12.5622 7.88239 38.3085 -7.50107 -2.24579 -520 1 1.15265 1.71178 2.84381 -8.4531 -11.9611 -9.59212 -521 2 1.05399 2.26522 2.05124 -0.803687 -1.8039 9.5303 -522 2 1.83355 2.04817 3.41993 6.13064 16.5152 3.77918 -523 1 4.1533 15.0772 10.0179 -3.20174 -0.437736 -9.29092 -524 2 3.98656 15.1016 9.06421 1.0299 1.2944 4.52592 -525 2 5.05261 14.7702 10.1253 7.00528 -3.42074 -2.93025 -526 1 7.40026 2.22746 14.7687 6.49168 5.19513 -3.0061 -527 2 7.05161 1.63346 14.1063 -3.12724 -4.90201 -3.09738 -528 2 7.91685 2.87588 14.258 -12.5256 -3.95349 11.2802 -529 1 18.373 14.546 2.1576 32.8202 -8.56769 3.71586 -530 2 0.641523 14.7991 2.40659 -13.3331 -4.12423 -2.43111 -531 2 17.8688 15.3457 2.17573 -14.9783 16.0191 -2.18472 -532 1 10.0269 2.72027 12.9069 6.62939 -13.0178 -15.3878 -533 2 10.0552 2.15154 12.1041 -3.85604 9.52515 15.5624 -534 2 9.22213 3.24102 12.837 -1.7712 4.41938 -1.42751 -535 1 2.97754 8.87028 12.9985 -9.05038 -0.677068 -3.47801 -536 2 3.45417 9.69118 12.8049 -4.31376 -0.734034 1.18179 -537 2 3.62806 8.2766 13.3769 7.01874 -2.97808 -1.19575 -538 1 3.19567 8.6035 3.77658 -19.8399 -15.185 62.8422 -539 2 3.69787 9.2024 3.27039 20.7823 26.7884 -21.1607 -540 2 3.25417 8.93577 4.73429 1.71088 -18.6185 -45.3432 -541 1 5.68333 7.2353 8.59567 4.24349 7.94903 8.11652 -542 2 5.64033 6.27333 8.54735 -2.49289 0.630165 -0.0839225 -543 2 5.00997 7.53803 9.22801 3.10928 -6.89318 -6.51723 -544 1 14.901 1.57394 1.8387 15.5968 1.99798 -17.643 -545 2 15.036 2.2757 2.46438 -7.07983 8.8607 13.8203 -546 2 15.4483 1.85956 1.08282 -11.9705 -11.4344 6.74504 -547 1 8.60581 15.0641 0.724175 -1.0343 -0.581701 -1.65436 -548 2 9.36267 14.9264 1.3224 -11.0408 7.07619 -5.07103 -549 2 7.85377 14.5885 1.11097 4.42293 -0.805501 -0.698164 -550 1 15.4669 1.42093 7.20398 -6.02567 -16.758 -12.9624 -551 2 14.8047 0.91537 6.67859 11.4397 13.2212 12.6179 -552 2 15.1632 2.33261 7.23494 -7.42764 0.585266 4.6538 -553 1 4.96609 12.9239 18.4605 4.9692 1.49742 18.5571 -554 2 5.35493 12.9668 0.719228 -7.36506 -0.705061 -15.6984 -555 2 5.64055 13.3191 17.899 -0.422768 -0.432726 -0.922633 -556 1 15.3869 8.64959 18.0541 15.2167 5.00615 -15.1922 -557 2 15.9585 9.21901 17.4831 -18.3202 -12.4364 12.18 -558 2 15.1184 9.19177 0.153179 1.36579 6.92031 5.44875 -559 1 12.0051 3.11685 18.332 2.92261 2.37371 -0.430118 -560 2 12.2267 2.91556 0.611981 0.907964 -7.8545 -12.3252 -561 2 12.4512 2.48545 17.7302 -5.34745 5.71129 14.8863 -562 1 13.1901 12.7142 5.17454 1.37013 -5.58194 -4.10925 -563 2 13.4698 11.8626 4.7966 3.05379 7.74077 7.48289 -564 2 13.3871 12.6804 6.11832 -0.290674 -0.040691 0.190289 -565 1 6.14326 7.19304 0.194857 -1.9202 -41.4233 1.79985 -566 2 6.22321 8.10871 19.0299 -3.97355 27.3971 1.06104 -567 2 5.34431 6.86352 0.645447 4.46952 5.26437 -3.48858 -568 1 17.7307 15.8888 14.9367 -21.823 -0.594011 -1.7362 -569 2 16.7484 15.9241 14.9389 21.2696 3.13718 0.352088 -570 2 17.9521 15.7271 14.013 1.78287 0.501162 -2.11552 -571 1 13.1218 0.925759 16.6825 5.50042 -3.78674 2.95198 -572 2 14.072 0.793445 16.8378 -4.97223 1.91263 -2.37602 -573 2 12.7827 0.0340456 16.5234 -2.01103 3.41826 1.69274 -574 1 10.8951 14.5133 7.41586 13.7556 -0.655539 -10.0126 -575 2 10.113 14.0867 7.762 -7.55253 -2.39401 4.078 -576 2 11.587 13.8348 7.46973 -1.14 7.89944 2.21203 -577 1 17.6887 8.43188 2.14728 0.189858 20.0466 16.1607 -578 2 16.8137 8.45099 2.54699 -1.17102 1.13639 1.13697 -579 2 17.5844 7.88298 1.39033 0.906265 -19.3865 -19.2668 -580 1 12.4753 7.78007 2.02858 4.8513 20.3782 0.840615 -581 2 12.1866 8.68618 1.79587 0.511972 -15.0552 5.00442 -582 2 12.026 7.17575 1.43189 -2.95773 1.13832 -8.42618 -583 1 12.0482 14.5597 10.5042 0.0757192 -7.5571 -35.1431 -584 2 12.4064 14.4181 9.58152 -17.4466 3.18024 31.1693 -585 2 11.0871 14.7065 10.4137 10.382 -0.64313 -2.04102 -586 1 6.77399 6.81718 15.4895 -2.25325 13.5751 22.5023 -587 2 7.66157 7.15195 15.2455 -13.2429 -8.30723 6.82645 -588 2 6.46823 7.3192 16.2828 11.602 -10.345 -19.2772 -589 1 7.96932 4.46689 13.3146 44.2968 21.2749 25.8476 -590 2 7.30275 4.56825 12.6635 -24.5307 9.83264 -18.6775 -591 2 8.36434 5.36687 13.4905 -14.8867 -29.3495 -5.61281 -592 1 13.3256 12.2141 14.3822 1.63527 0.767161 7.05401 -593 2 13.3071 11.2456 14.3976 -5.0343 3.13323 -4.4607 -594 2 13.6638 12.4664 13.5147 0.299935 -1.6824 -0.371902 -595 1 14.5332 9.57639 7.29372 1.70864 -17.4355 -8.36329 -596 2 15.3543 10.0193 7.49698 9.6305 7.8311 1.84335 -597 2 13.8455 10.0241 7.76467 -11.6358 9.67674 12.3645 -598 1 12.6873 16.8129 3.32056 7.83014 22.6359 -6.17069 -599 2 12.905 17.3242 4.12577 -3.6908 -4.91509 -14.526 -600 2 12.6713 17.4548 2.56832 -2.22777 -11.4506 21.1383 -601 1 1.00404 7.03926 17.3541 -3.3312 4.1638 -9.33324 -602 2 0.198847 6.6977 17.7452 -7.86562 1.94891 9.68399 -603 2 0.682364 7.69734 16.7196 12.0745 -4.24482 -2.37704 -604 1 12.9524 4.87174 15.7195 8.90342 0.650689 -3.85785 -605 2 13.7851 4.36673 15.5939 -16.3603 12.0475 7.07164 -606 2 13.1756 5.81397 15.8059 7.81047 -7.07308 -0.568692 -607 1 2.31363 3.41121 5.09984 1.34414 -8.27729 12.6429 -608 2 1.77118 2.94066 5.78541 14.4044 18.7697 -14.1923 -609 2 2.78995 4.15649 5.52715 -11.381 -10.4766 -6.15296 -610 1 8.18617 10.9369 13.7076 0.678078 1.53711 40.2692 -611 2 8.26353 10.8511 14.7174 0.0908521 -0.97824 -49.4206 -612 2 8.97116 10.5326 13.3071 -0.268246 2.83437 5.42064 -613 1 12.9797 1.57395 13.2253 -11.1668 13.2146 -3.30054 -614 2 13.4836 1.606 12.3812 -13.0456 2.80048 17.4401 -615 2 12.3844 2.37352 13.292 24.5144 -24.3843 -9.90982 -616 1 6.623 13.6575 2.08401 -19.1133 11.282 9.3836 -617 2 5.9939 13.9784 2.7781 14.9337 -6.87798 -17.2483 -618 2 7.26745 13.1178 2.55198 -2.04458 -0.845032 2.89429 -619 1 15.8406 6.42424 12.5401 -13.2713 -11.8586 11.2716 -620 2 16.4194 6.98592 12.0445 9.49352 10.2235 -13.5209 -621 2 16.1454 6.51524 13.4484 4.14662 -0.822673 1.52229 -622 1 16.7707 0.701968 9.54479 -0.33564 -15.5889 9.3319 -623 2 16.6398 18.4357 9.88026 3.64558 8.61996 -2.27841 -624 2 16.2643 0.755347 8.72872 -0.899564 4.78829 -7.90839 -625 1 6.16924 11.6733 8.25771 14.6298 -10.0406 -3.26225 -626 2 5.33846 11.3866 8.66461 9.26092 -3.17897 1.03444 -627 2 6.69681 10.8652 8.03849 -20.9756 15.4878 5.14008 -628 1 2.79271 8.6573 0.35403 -23.76 -9.02274 -22.2632 -629 2 2.25448 8.23641 18.2541 16.977 17.0562 34.1458 -630 2 2.21462 9.29512 0.821612 5.57875 -9.71134 -10.0126 -631 1 10.106 10.3292 6.60358 -3.61165 1.9136 -10.2284 -632 2 10.6792 9.71276 7.06962 0.244318 -4.43661 2.14915 -633 2 10.3272 10.2595 5.65755 0.987804 2.37269 11.054 -634 1 6.86896 15.7547 6.74185 -9.45188 0.350857 10.5778 -635 2 7.01957 16.2495 7.56813 1.20841 -3.75655 -8.95365 -636 2 6.86937 16.4078 6.03145 5.97827 -1.66506 -1.56051 -637 1 6.52554 12.9289 5.84178 -0.357514 -5.09084 -2.41361 -638 2 6.62829 13.798 6.2286 3.16894 9.75908 1.28602 -639 2 6.09212 12.3914 6.51525 3.69897 1.96572 0.733322 -640 1 16.7568 12.518 9.72465 -9.23185 -13.2632 0.47822 -641 2 16.902 11.7866 9.09243 0.130969 14.0381 8.74694 -642 2 17.3592 13.2171 9.48659 4.61146 3.47499 -3.98224 -643 1 6.24919 2.86496 2.77119 -11.0856 -12.869 -3.38869 -644 2 6.47325 3.75226 2.51474 6.07925 14.4727 -0.649249 -645 2 5.68088 2.55654 2.04869 4.52067 -4.17334 4.94091 -646 1 10.7277 3.04594 3.24275 -5.68944 3.06595 0.875255 -647 2 10.1765 3.79746 3.50451 2.82785 -3.23936 -2.03517 -648 2 10.278 2.63972 2.48897 0.815959 0.513447 0.723514 -ITEM: TIMESTEP -90 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.787 6.66827 17.9842 -16.1402 -3.16192 1.04025 -2 2 7.92621 6.66814 18.4555 15.1954 -0.455805 -12.5376 -3 2 8.71175 6.0436 17.2441 2.25338 3.19171 10.1252 -4 1 0.22099 8.38854 6.75163 1.7867 -5.58088 53.0968 -5 2 0.258391 8.22026 5.83332 5.30707 -13.3892 -38.1472 -6 2 0.61579 7.61263 7.23543 -10.6686 22.8516 -15.6901 -7 1 8.66795 0.370206 6.9239 18.6241 3.37743 -9.56875 -8 2 9.59619 0.315354 6.61478 -16.3273 1.21351 7.23111 -9 2 8.27983 1.03351 6.33448 -2.90229 -5.54848 4.92815 -10 1 6.43573 1.74596 11.7835 34.1799 -16.6044 -13.764 -11 2 5.93979 2.40996 12.1988 -27.1883 29.6469 18.8725 -12 2 5.80753 1.07598 11.5419 -8.40397 -16.9848 -5.34211 -13 1 6.95318 5.50156 2.37044 -56.4905 40.6357 15.9903 -14 2 6.31995 5.85318 3.09808 38.0444 -22.8427 -29.8317 -15 2 6.63738 6.03683 1.59693 20.7004 -19.4106 17.4304 -16 1 16.2563 10.1963 16.0713 -10.5934 -3.27458 3.94447 -17 2 16.9716 10.3961 15.4827 15.3322 4.9096 -4.70747 -18 2 15.8903 11.0434 16.3496 -2.84586 0.096923 -3.72852 -19 1 10.8156 14.9572 2.29652 -13.5477 -14.1276 -10.2117 -20 2 10.6343 14.4303 3.07787 2.79926 -3.05354 4.26547 -21 2 11.1766 15.7627 2.6355 11.3372 16.7492 6.7502 -22 1 17.2002 8.21443 10.9436 15.2126 5.40823 -8.20499 -23 2 16.6458 8.84622 11.4125 -4.33506 2.62691 -0.328418 -24 2 17.9515 8.74734 10.6145 -8.68143 -7.05886 2.54317 -25 1 14.6067 16.0259 16.3377 27.3765 -5.03456 2.51249 -26 2 13.6996 16.2768 16.4047 -22.3019 9.86517 -5.17321 -27 2 14.7963 15.6285 17.196 -1.96556 -8.36093 -2.03831 -28 1 12.1458 13.2907 0.563101 15.519 -14.4585 7.5186 -29 2 11.8598 13.3671 18.2945 -8.9445 7.51312 -6.12139 -30 2 11.6592 13.8773 1.15113 -3.3891 6.78651 -5.827 -31 1 9.32161 5.49231 3.86239 -40.7454 -0.097831 27.7 -32 2 8.82419 5.45502 4.73277 24.2157 -2.28744 -25.4595 -33 2 8.56838 5.45751 3.23664 18.1191 1.43276 -0.568008 -34 1 1.5546 3.92475 11.5547 -2.15894 45.2634 -4.40984 -35 2 1.55046 4.88574 11.8201 -3.55694 -26.3933 -6.97822 -36 2 1.92957 3.45678 12.2837 10.4321 -13.9157 16.7147 -37 1 2.10319 6.96614 8.15085 -9.44208 -8.37285 -17.308 -38 2 2.4095 7.43328 8.92365 8.57391 0.445975 10.2393 -39 2 2.10294 6.01871 8.3456 1.70875 2.69997 7.84786 -40 1 5.23855 4.482 7.82422 -14.5525 -1.69806 -15.7353 -41 2 5.37847 3.52895 7.72628 3.24739 1.15002 6.52498 -42 2 4.55634 4.7134 7.1559 12.5144 1.33119 10.811 -43 1 3.38552 2.88255 17.3879 -7.38377 33.0145 14.859 -44 2 4.08387 3.35622 16.9066 -6.09174 -4.5148 -0.339366 -45 2 2.81217 3.57956 17.8286 22.0641 -22.8641 -14.398 -46 1 7.5324 5.43864 6.19559 -6.90202 6.90038 35.1799 -47 2 8.08818 5.95892 6.84983 -22.5477 -17.4794 -25.4925 -48 2 6.78022 5.04202 6.71812 26.5249 9.35209 -13.645 -49 1 9.82024 7.03039 12.0775 19.8901 0.0780072 21.9724 -50 2 10.117 6.21395 11.6931 4.07542 -9.22938 -4.80372 -51 2 9.09589 7.30435 11.5485 -23.243 9.22364 -20.0663 -52 1 13.9806 3.7694 8.09667 -19.6388 4.31534 -31.7671 -53 2 13.3819 4.49155 7.81719 15.167 -9.87345 1.12215 -54 2 14.3046 4.00637 8.94223 9.52837 8.93591 30.7953 -55 1 4.52742 17.134 3.88467 -0.450754 13.2049 4.39156 -56 2 5.37483 17.5703 4.13521 -18.32 -2.84079 -10.9512 -57 2 3.94957 17.708 3.32475 23.4139 -10.9615 8.41036 -58 1 16.2726 16.5634 10.552 38.1711 -6.17539 -26.5181 -59 2 15.4837 16.6086 11.0514 -31.396 0.528555 16.213 -60 2 16.0986 15.9648 9.80419 -5.24542 6.81385 7.69127 -61 1 1.94125 4.78402 0.0638345 24.0582 25.3647 11.1071 -62 2 2.62474 5.1599 0.67023 -17.1428 -14.5257 -4.57865 -63 2 1.76164 5.54704 18.141 -7.28608 -7.40463 -3.41134 -64 1 11.2518 13.2771 16.4354 2.60185 -12.9515 -12.3757 -65 2 10.6918 12.4717 16.5304 19.7397 14.6013 -5.52798 -66 2 11.8919 13.1107 15.7025 -16.8897 -0.368153 14.685 -67 1 10.0575 10.919 16.7613 6.16873 -18.0385 3.66167 -68 2 10.4442 10.0133 16.8612 -13.1447 30.924 -0.515142 -69 2 9.09987 10.8482 16.7186 0.711039 -4.16381 0.34444 -70 1 11.8614 17.5086 13.5019 6.48767 -7.71286 -13.5562 -71 2 12.4999 17.0938 12.8959 -9.94411 -4.10313 8.27478 -72 2 12.0757 18.4326 13.4127 -0.0140719 16.2542 2.74368 -73 1 6.39981 9.50139 12.337 -4.6648 -8.8035 -19.3883 -74 2 6.97362 9.2422 11.6012 -0.80266 1.15987 5.77958 -75 2 6.9622 9.95325 12.9581 6.38846 6.66359 6.95977 -76 1 16.2975 12.8974 2.78222 -12.345 -27.8929 4.9875 -77 2 17.1496 13.2141 2.51749 15.349 9.48057 -2.38836 -78 2 15.7502 13.672 2.87844 -10.3717 9.81447 0.854078 -79 1 0.774 12.7819 5.86324 -32.223 -2.64552 -12.7856 -80 2 1.10971 12.9185 4.95432 -4.25214 -7.81578 11.8108 -81 2 18.4306 12.6074 5.76822 36.341 8.50215 1.05579 -82 1 5.29891 16.3721 18.4261 6.47 -16.9938 9.7884 -83 2 5.51669 15.4746 18.1046 -4.53971 18.6444 -2.10572 -84 2 5.85038 16.4657 0.570301 -5.83847 6.29943 -2.02707 -85 1 0.695227 7.70772 4.16735 36.5725 18.4792 -22.7587 -86 2 0.10368 7.96447 3.43723 6.76909 -3.37176 10.733 -87 2 1.60166 8.10351 3.91123 -45.3891 -20.8895 14.9183 -88 1 3.19365 9.10151 6.50287 -37.0597 -13.4257 3.63648 -89 2 3.6513 8.68447 7.23829 0.216969 0.250287 -1.31356 -90 2 2.24726 8.75126 6.54108 37.1121 17.8096 0.286984 -91 1 7.35199 10.4473 16.1779 -19.0362 -10.3824 27.97 -92 2 6.56517 10.9544 15.9216 9.49501 -5.7134 5.26362 -93 2 7.13832 10.0279 17.0488 0.309364 15.3336 -19.7914 -94 1 11.0163 0.890853 5.00632 -3.98909 -12.3472 3.8442 -95 2 10.8807 1.76939 4.61668 6.53092 -8.55309 -4.92776 -96 2 10.738 0.225438 4.34173 2.35985 18.608 2.04389 -97 1 4.21667 2.95093 13.149 10.2014 -19.1015 31.4776 -98 2 4.53515 3.41914 13.9504 -8.71013 -4.86526 -13.316 -99 2 4.15898 1.99936 13.4513 -0.534052 25.4454 -15.6313 -100 1 8.50322 10.2612 1.79208 -4.34668 -17.3092 21.2914 -101 2 8.27549 10.8526 2.5321 5.30441 -1.44182 -6.44774 -102 2 8.58493 9.36982 2.21324 2.85947 21.4101 -9.02924 -103 1 10.3161 1.69184 15.4745 -6.1912 0.342966 -7.58309 -104 2 11.1781 1.38278 15.7166 17.9205 -0.758309 5.87707 -105 2 10.347 1.84648 14.5196 -5.50104 2.18071 3.0962 -106 1 2.60936 12.9662 7.92592 -2.1007 2.96569 -8.82009 -107 2 3.10883 13.7131 7.55922 1.74385 -4.33572 0.675454 -108 2 1.96491 12.7329 7.23617 6.25685 -1.04193 4.90183 -109 1 3.83706 11.6816 4.96058 -22.5573 -14.4893 8.95363 -110 2 3.56827 11.1846 5.76493 10.0033 8.11351 -16.9036 -111 2 3.08816 11.5736 4.33469 10.7007 11.5305 11.906 -112 1 6.6582 14.5337 16.9912 3.19916 -10.5164 -7.18554 -113 2 7.36558 15.1576 17.1605 2.12516 -0.469731 1.77687 -114 2 6.47854 14.5937 16.0445 -2.82585 4.49818 1.60201 -115 1 14.2037 14.4903 3.21857 16.956 -7.57282 -16.8086 -116 2 13.9492 15.374 3.44691 -9.21692 15.261 -0.929302 -117 2 13.8764 13.9351 3.91269 -8.69982 -10.6193 13.7942 -118 1 8.69855 18.0357 16.1264 41.5507 -6.08144 10.5978 -119 2 9.33855 17.4056 16.5195 -30.3672 -5.67283 -6.86348 -120 2 9.34419 0.0405339 15.8183 -19.2067 16.0047 -5.03817 -121 1 4.69307 1.79842 4.89677 16.2385 30.5389 -26.6001 -122 2 3.80396 2.19318 4.80489 14.8244 -2.46841 6.40587 -123 2 5.29999 2.32882 4.27745 -28.5893 -25.5208 24.7929 -124 1 15.0277 12.5795 16.5521 32.6678 1.07726 26.51 -125 2 14.723 12.7481 17.4682 -6.07814 3.10734 -21.8061 -126 2 14.3421 12.5499 15.8992 -22.7964 0.862239 -7.92322 -127 1 15.7044 18.5089 16.8468 26.9219 -3.0014 45.6431 -128 2 16.268 18.6119 17.6883 -20.0241 -2.05323 -42.0683 -129 2 15.5234 17.5608 16.7959 -6.5303 3.1055 -1.70461 -130 1 1.37672 1.34924 16.652 -10.0314 2.12664 3.94932 -131 2 2.13238 1.94076 16.8287 -14.5592 -12.7899 -0.0819953 -132 2 0.657997 1.59844 17.2733 17.8805 -0.89879 -9.33461 -133 1 18.2331 4.34642 15.9005 -0.884234 -3.04582 -21.1642 -134 2 17.8346 3.73179 15.2509 9.01129 10.3034 11.7071 -135 2 0.449037 4.61451 15.5361 -9.49368 -5.77709 6.1071 -136 1 12.1007 17.0847 16.1341 -21.8736 -13.8645 50.4236 -137 2 11.3773 16.6353 16.6829 29.7152 15.2039 -30.2146 -138 2 11.8045 17.1565 15.2358 -4.92233 -3.24187 -16.5992 -139 1 16.1203 2.66556 18.245 -33.6191 11.8512 -24.8852 -140 2 15.5683 3.39571 18.6154 19.5646 -10.4389 -9.45588 -141 2 15.8602 2.60471 17.2935 4.4965 0.524143 22.3318 -142 1 6.68711 13.7575 10.0686 6.57394 0.780895 15.4701 -143 2 6.65896 13.3749 10.963 -3.37269 2.77311 -6.77332 -144 2 6.71723 13.0193 9.46247 -3.0919 -8.05072 -6.49535 -145 1 10.1832 18.4638 2.68288 15.4984 11.1175 -14.1442 -146 2 10.4797 0.410785 1.94548 -7.56539 -13.8801 19.3089 -147 2 9.29042 18.2071 2.48382 -12.5464 -2.66261 -5.58966 -148 1 3.06565 17.654 6.19973 -11.4817 2.82915 -15.5316 -149 2 2.17867 17.6912 5.79869 7.15707 -3.68965 15.0105 -150 2 3.60434 17.7569 5.40979 11.429 -4.57556 5.13078 -151 1 12.6359 16.7831 7.87678 -34.4323 5.42099 5.88286 -152 2 11.8215 16.2589 7.70694 19.4452 0.972157 -0.554869 -153 2 12.3283 17.4377 8.53506 12.9634 -4.48143 -6.06952 -154 1 14.8812 15.2555 8.26349 -9.13488 6.23831 13.721 -155 2 14.2179 15.9485 8.09528 6.25869 -7.42326 0.874894 -156 2 15.4123 15.1764 7.46942 0.572987 8.13089 -2.89012 -157 1 17.8363 18.2748 0.235726 -36.9104 2.14965 -2.72595 -158 2 18.5544 17.6878 0.132306 25.4932 -25.6882 -8.95291 -159 2 18.2375 0.371142 0.648791 5.78715 27.9621 12.2792 -160 1 0.76648 10.5228 1.42349 -23.6052 -44.6853 36.9297 -161 2 -0.0625164 10.0248 1.72181 36.7073 15.4552 -13.6362 -162 2 0.483164 11.1861 0.82966 -10.4498 25.872 -24.2739 -163 1 1.81496 12.3027 3.28068 4.06427 7.40541 18.1542 -164 2 1.38036 11.6556 2.74613 -8.62838 -16.0879 -14.4133 -165 2 2.12935 12.9782 2.6808 0.203437 6.54347 -1.70293 -166 1 0.715096 17.2857 4.99328 6.02973 16.9927 -22.851 -167 2 -0.0549074 17.8034 5.17132 -8.63108 24.1627 -3.07112 -168 2 0.561936 16.5317 5.51148 1.70853 -39.3498 23.4345 -169 1 1.0126 0.815092 9.34853 9.77893 1.05612 10.9097 -170 2 1.24172 0.537916 10.2451 4.93082 3.28815 4.21298 -171 2 0.133534 0.483606 9.24599 -18.3012 -2.93221 -7.23643 -172 1 16.7899 2.36695 13.4143 1.34336 11.0529 -24.546 -173 2 16.9036 2.71504 12.491 -0.235106 -7.90147 26.8103 -174 2 16.4417 1.47344 13.309 3.25474 -1.82726 5.59598 -175 1 2.66167 16.0077 12.0598 12.6303 -22.6944 6.71055 -176 2 3.01062 15.6298 12.8947 -8.01809 9.38789 -15.4913 -177 2 3.11281 15.5097 11.3415 -7.7677 12.8204 10.8964 -178 1 16.364 15.512 6.14932 19.0855 9.58845 -19.9598 -179 2 17.3177 15.4404 6.40388 -23.0707 9.20906 -7.80583 -180 2 16.2465 16.2844 5.52559 8.28806 -24.9431 19.8586 -181 1 5.77951 5.20043 11.8033 8.47507 -20.9263 -15.707 -182 2 5.6405 6.00993 12.2754 -6.27864 14.793 10.9641 -183 2 5.18835 4.5564 12.2066 -2.11002 -1.11499 -2.91817 -184 1 15.1794 4.92089 0.775894 -18.0102 -8.76269 31.4284 -185 2 14.9497 4.67568 1.72392 8.26683 8.97624 -32.6089 -186 2 14.3636 5.23769 0.366515 4.70525 -0.664057 3.69432 -187 1 16.3975 16.4382 1.83859 15.8969 -1.83249 -31.9545 -188 2 16.3175 16.7184 2.73629 -8.02889 11.6848 21.5541 -189 2 16.8259 17.1655 1.34034 -8.03244 -7.80667 10.4102 -190 1 0.153841 4.83744 3.963 18.3567 41.8245 -8.83163 -191 2 0.481764 5.78512 3.86014 -17.0028 -34.1388 7.97498 -192 2 0.952119 4.32423 4.11352 -0.77715 -2.59924 4.82879 -193 1 2.94647 15.0748 15.1079 -17.5423 -9.74792 39.2804 -194 2 2.84668 14.6538 16.0052 7.88621 4.55617 -28.9019 -195 2 2.37581 15.8415 15.2342 5.36547 9.02165 -11.4736 -196 1 1.04118 14.6398 9.41517 21.0794 -20.4815 -17.0137 -197 2 1.63478 13.9208 9.06194 -19.3512 25.5288 8.96267 -198 2 0.7851 14.3144 10.2695 -7.28135 -4.68142 11.1743 -199 1 13.5343 16.512 11.5541 0.415781 17.9887 -13.1724 -200 2 13.2087 17.3014 11.0493 5.42519 -19.6136 10.4452 -201 2 13.1525 15.7431 11.1062 -5.37134 4.1326 5.42785 -202 1 4.79073 1.57335 0.678685 -10.2425 -16.6589 -0.602312 -203 2 4.2243 2.02466 0.0269211 5.06007 -3.50169 9.95598 -204 2 4.26355 0.829094 1.04695 5.40097 16.8315 -2.73739 -205 1 1.55169 18.6011 11.9401 -14.2618 14.3088 -13.4455 -206 2 1.54559 0.423493 12.7773 -0.760074 5.21042 2.72529 -207 2 2.10509 17.8447 12.0596 11.7149 -17.0814 4.30068 -208 1 11.3926 10.0859 4.15406 35.1149 20.4659 -18.5884 -209 2 11.4922 10.6036 3.30306 -8.07316 -21.3073 26.3838 -210 2 12.3257 9.94393 4.45754 -25.8381 1.71308 -8.95455 -211 1 8.18732 12.2257 3.75704 -12.727 -0.351394 27.2441 -212 2 9.08394 12.5468 4.00553 -19.5779 -3.96369 2.83586 -213 2 7.55786 12.2705 4.55735 35.1927 2.13842 -31.3906 -214 1 14.6183 4.0143 3.36201 13.432 11.2186 16.7224 -215 2 15.2472 4.27703 4.07585 -12.4329 -9.47893 -15.9273 -216 2 13.7521 4.30159 3.67007 -0.91716 0.860244 -2.07153 -217 1 5.73358 1.67843 7.60794 -24.3615 -22.8066 38.6551 -218 2 5.03202 1.06037 7.9982 26.7251 29.011 -15.8684 -219 2 5.4689 1.83957 6.71483 -6.40801 -4.86943 -26.9957 -220 1 17.8709 0.966847 4.84319 9.19834 18.9135 -13.8104 -221 2 18.365 1.30942 4.06688 -7.16187 -11.4028 13.2983 -222 2 17.8528 1.72071 5.45189 -4.56365 -9.98849 0.137087 -223 1 6.8232 9.21412 4.53503 0.0591715 -6.07859 -16.7729 -224 2 6.61803 9.33533 5.45725 2.71524 4.28405 13.1117 -225 2 7.76963 9.02928 4.48077 0.0640272 -1.66157 1.55662 -226 1 2.43776 14.707 2.05519 12.3789 -12.7502 -17.0618 -227 2 3.26162 14.6424 2.56361 -5.44595 2.48516 -0.426941 -228 2 2.66563 14.4192 1.14611 -3.66427 9.22898 15.3942 -229 1 17.2291 12.9271 13.0675 -25.7945 34.5425 2.40746 -230 2 16.3582 13.328 13.3279 21.6203 -16.0155 -5.62376 -231 2 17.7378 13.7209 12.8173 -0.837652 -12.191 -0.563337 -232 1 14.8245 10.5613 1.47762 -19.5687 -28.1113 -12.7998 -233 2 15.3117 11.2776 1.82539 19.2978 30.1093 14.6064 -234 2 13.9052 10.723 1.70642 0.475408 2.13461 -1.67485 -235 1 5.64982 6.63563 4.55084 7.38671 -15.2963 15.0755 -236 2 5.89214 7.54949 4.44479 2.16454 16.7651 -4.4857 -237 2 6.3044 6.30345 5.19757 -6.24708 1.07556 -9.93912 -238 1 8.10845 8.3271 10.3627 -2.57156 5.78827 13.3728 -239 2 8.61892 8.85799 9.7482 5.06505 3.86155 0.738683 -240 2 7.30116 8.09886 9.91192 -6.7312 -10.1116 -10.9746 -241 1 13.4488 18.4608 5.65963 -13.3307 -19.6223 8.99938 -242 2 12.6096 0.239632 5.39678 7.81848 3.10411 6.37483 -243 2 13.1935 17.7385 6.2846 5.11891 19.4349 -8.45882 -244 1 -0.00278136 2.5625 0.408955 -12.183 35.1922 -19.112 -245 2 17.7147 2.60224 18.7259 18.9642 -9.11891 12.7486 -246 2 0.290302 3.48872 0.227759 6.22068 -26.2608 7.60118 -247 1 12.9842 10.8497 9.70117 -72.6257 27.1129 -13.2266 -248 2 11.97 10.965 9.69449 48.4921 6.31007 0.109369 -249 2 13.0048 9.91956 9.83068 16.3628 -25.292 6.36111 -250 1 0.548273 12.2593 11.2103 29.2233 3.63314 -8.31727 -251 2 18.2651 12.1894 11.4198 -11.8267 3.42799 7.99272 -252 2 1.06577 12.5175 11.9926 -12.6507 -2.71608 -2.06856 -253 1 5.24515 7.35168 13.3154 -11.9716 -5.94003 -7.6844 -254 2 5.73604 8.07931 12.9223 2.64227 5.43904 4.60776 -255 2 5.63818 7.16239 14.1672 7.7875 0.124539 4.29694 -256 1 1.16856 6.76355 12.0035 -37.5881 -40.6251 -19.8542 -257 2 0.334741 7.08942 11.6206 8.86965 -4.87383 5.4559 -258 2 1.63397 7.52151 12.2381 28.649 45.7996 14.9133 -259 1 15.5501 9.75639 12.3967 -1.92883 21.1886 15.8166 -260 2 15.1116 10.6344 12.221 21.3449 -31.3991 6.12972 -261 2 16.0605 9.85526 13.2245 -13.7753 0.465455 -14.4819 -262 1 16.5858 12.6354 5.59083 -2.62715 14.8355 -19.0185 -263 2 16.4437 13.5882 5.83081 0.436603 -22.1434 -16.2318 -264 2 16.416 12.5171 4.60718 5.48378 12.0784 33.3147 -265 1 6.40279 9.86277 0.0794915 -20.3924 -8.41649 -9.56759 -266 2 5.55524 10.218 0.380594 4.23452 2.32222 -1.66862 -267 2 7.0555 10.2042 0.674211 16.128 4.48978 14.4774 -268 1 12.2427 6.01171 4.00399 -23.1281 -36.6346 24.2315 -269 2 12.2798 6.64894 3.31747 0.117026 23.2517 -16.0656 -270 2 11.2984 5.74139 4.08171 19.6095 7.84283 -4.73597 -271 1 0.360057 12.9056 0.031807 -8.11921 2.1908 5.08387 -272 2 18.8977 13.4796 0.805411 -3.72305 -1.59029 -3.55744 -273 2 18.3786 13.2516 18.0169 7.85083 -4.92073 3.80969 -274 1 3.55677 18.7152 8.66247 19.9063 -6.335 -5.44295 -275 2 3.49677 18.1902 7.8473 -5.97778 6.84736 4.02201 -276 2 2.66917 0.348355 8.87781 -8.06089 0.921211 -3.36616 -277 1 7.26214 17.4262 4.43744 19.2672 26.0801 -3.30237 -278 2 7.75433 18.2474 4.74147 -22.4281 -27.0983 -14.818 -279 2 7.37471 17.3728 3.46226 -1.25032 2.03681 18.5343 -280 1 9.25258 17.1703 12.1759 28.8617 -14.1678 9.07352 -281 2 9.26958 16.3393 11.6513 -2.57153 16.4076 7.11435 -282 2 10.1283 17.1978 12.6604 -29.6357 0.448077 -14.593 -283 1 13.2677 13.193 7.99719 -21.1722 -32.5843 10.0566 -284 2 13.3388 12.6042 8.77917 0.104276 5.764 -17.169 -285 2 13.8077 13.9427 8.17139 23.4211 18.1414 5.93605 -286 1 14.7593 2.91325 15.4943 24.3728 -2.49696 -23.5999 -287 2 14.0361 2.3713 15.1546 2.238 -3.60609 4.01929 -288 2 15.4274 2.94021 14.7667 -15.6113 -2.56038 15.0831 -289 1 9.9738 15.6484 16.9671 -8.54083 0.59912 -5.05632 -290 2 10.1057 14.7848 16.5569 10.1368 1.85589 1.18764 -291 2 9.46144 15.457 17.7506 -1.80616 -1.66933 10.9911 -292 1 11.2344 8.55758 16.6355 7.77426 1.92795 -6.45244 -293 2 10.4646 8.11257 16.295 -8.96701 -9.58703 -5.10609 -294 2 11.6991 7.91388 17.1598 3.61158 -8.68538 8.99751 -295 1 4.14955 18.3179 16.8036 -6.71252 9.00681 -6.36217 -296 2 4.47312 17.6803 17.4466 6.33314 0.74429 2.85153 -297 2 4.24503 0.569095 17.1648 -0.42517 -11.8307 0.148866 -298 1 2.33957 4.29184 8.91302 22.2448 -7.34702 27.8454 -299 2 3.30686 4.08394 8.81247 -29.123 7.66299 4.05924 -300 2 2.12598 4.16624 9.8839 8.54186 0.354435 -34.7065 -301 1 9.95255 10.4179 9.8571 -18.8164 27.0404 -12.2944 -302 2 9.4534 11.1894 9.4744 17.3372 -21.5482 9.10503 -303 2 9.8309 10.4683 10.8129 6.92766 -2.76642 -0.156957 -304 1 9.80127 0.922938 10.8108 4.3272 3.59983 6.04006 -305 2 9.35046 0.175669 11.2139 0.840012 -6.18623 1.13214 -306 2 9.1369 1.38463 10.2905 0.460774 -0.831922 -5.90435 -307 1 9.16459 15.1765 10.2101 -26.8722 -7.06493 -21.2153 -308 2 8.97785 15.8968 9.57551 3.0406 -6.31351 13.2231 -309 2 8.39419 14.5643 10.0571 23.5779 16.7742 11.4525 -310 1 0.773683 9.7544 10.1833 18.261 11.1305 -23.2394 -311 2 0.868202 10.7262 10.3345 -3.82315 -24.612 -0.100636 -312 2 1.30536 9.53677 9.37727 -17.4146 8.84667 24.1623 -313 1 17.2096 4.87642 8.04469 -12.9959 -9.21067 35.1395 -314 2 16.3347 5.16277 8.3943 19.7751 -0.094318 -9.55648 -315 2 17.6197 4.3572 8.78272 -10.3132 11.9302 -24.4143 -316 1 14.8095 14.6496 0.0373288 -5.69372 -9.04424 21.9283 -317 2 15.5101 14.9524 0.640087 -10.906 0.748239 -2.66247 -318 2 14.0769 14.3265 0.613297 14.425 8.36295 -12.6903 -319 1 3.89537 11.0996 9.55593 -9.82967 16.3938 -0.398364 -320 2 3.93242 11.2996 10.5001 -1.21387 -1.78602 1.5381 -321 2 3.39392 11.8407 9.15947 5.2768 -13.1919 0.569667 -322 1 11.4169 10.7371 1.49225 5.47317 24.4145 -6.81884 -323 2 11.5532 11.6314 1.08329 0.074839 -23.6179 10.2373 -324 2 10.4618 10.6109 1.50924 -1.9569 -1.96948 -2.8184 -325 1 13.1395 7.21524 12.5729 -20.455 -7.16835 0.858137 -326 2 14.0577 7.03675 12.4308 23.1896 -1.74136 0.0778831 -327 2 12.7378 6.3322 12.608 -1.47964 6.92135 2.9072 -328 1 9.65614 1.96645 0.86496 18.1931 4.09637 20.8777 -329 2 8.84682 1.67677 0.484793 -23.8326 -3.90796 -8.97572 -330 2 10.1746 2.31935 0.150168 8.91513 5.01659 -9.40528 -331 1 10.6386 13.4197 4.53193 2.28663 -4.65747 18.8344 -332 2 11.4948 12.9639 4.69275 -16.1918 12.7288 -0.469196 -333 2 10.3958 13.8423 5.38242 9.30576 -5.17735 -13.1714 -334 1 14.5273 1.57884 10.9459 15.1221 22.4117 -0.776229 -335 2 15.362 1.31139 10.5257 -10.7732 -5.17355 3.70166 -336 2 14.6474 2.54531 11.0746 -6.11584 -12.5888 -6.32845 -337 1 14.4766 12.0159 11.6273 -10.9263 4.56586 -44.1867 -338 2 15.2047 12.4077 11.0864 -12.0042 -9.95663 15.0185 -339 2 13.8634 11.5981 10.9451 22.3117 17.3775 30.6101 -340 1 8.16847 5.14124 9.81669 -29.5484 17.7318 23.7918 -341 2 7.27475 5.12719 10.2684 30.6512 -1.40914 -16.6308 -342 2 8.33799 4.26267 9.50012 -3.06916 -18.2431 -3.24008 -343 1 1.5108 16.9662 18.5044 9.55151 26.7901 -23.2493 -344 2 1.84435 17.2897 17.6363 -7.76754 -5.77411 19.656 -345 2 1.83481 16.0826 18.5596 5.96378 -22.3257 1.76596 -346 1 1.42717 17.3886 15.3379 47.0554 -13.0927 -7.45492 -347 2 1.50543 18.1882 15.8264 3.14075 27.3625 12.617 -348 2 0.523906 17.2066 15.2924 -49.7083 -12.5335 -2.74225 -349 1 3.49173 5.73723 6.04987 -5.63889 12.5308 6.32322 -350 2 3.05134 6.46754 6.5425 11.5005 -15.9447 -9.63575 -351 2 4.14223 6.14285 5.45548 -4.8412 1.1033 3.2125 -352 1 12.5916 9.51872 14.2408 10.4293 -27.0271 -12.8548 -353 2 13.028 8.79356 13.6831 -19.628 26.0366 30.4849 -354 2 12.3513 9.14884 15.1174 6.55215 0.813797 -17.5332 -355 1 4.09544 15.2089 7.12218 31.8609 13.6269 2.32941 -356 2 3.67616 16.0257 6.80924 -1.84113 -5.17266 1.34804 -357 2 5.07546 15.4284 7.13078 -32.8392 -10.6488 -3.17146 -358 1 0.799143 8.79431 15.1488 8.21516 12.8732 -16.9375 -359 2 0.575284 9.7423 15.0796 -2.5473 -12.0602 5.3867 -360 2 1.52676 8.70151 14.5038 -8.32138 -2.51513 8.31525 -361 1 12.8725 8.28632 10.0993 13.5644 -10.3417 -12.785 -362 2 13.6812 7.81606 9.78663 -13.8637 7.80766 13.5238 -363 2 12.7502 8.10095 11.0322 6.24745 -8.27276 5.3213 -364 1 15.2423 7.98405 3.44353 15.6799 19.5655 -11.9659 -365 2 14.4463 7.83544 2.89643 5.54982 -16.2362 17.4101 -366 2 15.5184 7.39607 4.17406 -22.72 2.15229 -11.0841 -367 1 17.1687 6.76019 0.0376092 -10.314 6.5713 -12.413 -368 2 16.7239 5.93548 0.292072 -0.0664332 9.88195 -1.29815 -369 2 16.4741 7.34647 18.2846 16.8516 -16.4801 16.1304 -370 1 8.96925 6.98328 7.86383 -27.8745 -15.8066 22.0328 -371 2 9.86939 7.24269 7.81058 30.3142 9.1639 -3.03437 -372 2 8.87474 6.48936 8.713 -1.39219 10.6855 -19.1169 -373 1 12.482 0.614891 1.23015 1.92335 -8.70167 1.10105 -374 2 13.2432 1.03802 1.64803 2.06157 -2.24376 -3.30204 -375 2 12.803 0.16068 0.442821 -0.913907 6.47573 3.0001 -376 1 5.66871 15.0647 14.4598 7.14191 19.2454 -5.51099 -377 2 4.75956 15.0903 14.7907 1.11348 4.01334 -3.77227 -378 2 5.94804 16.0038 14.294 -6.0872 -24.4911 3.70117 -379 1 3.73529 6.48244 1.70347 -4.32476 7.10488 -19.4811 -380 2 3.3805 7.26573 1.22404 3.0021 -10.505 14.7125 -381 2 3.73285 6.71028 2.6365 -0.71904 4.06656 1.73817 -382 1 3.86925 11.322 12.3296 2.55777 5.65869 0.326193 -383 2 4.7048 11.7602 12.5386 0.0734552 -4.93202 -1.70743 -384 2 3.20028 11.8652 12.7549 -2.96009 3.18005 0.676376 -385 1 5.3196 3.88545 15.7107 -12.565 72.4648 14.1271 -386 2 6.00107 3.31 15.4478 35.5939 -28.3589 -8.92722 -387 2 5.74724 4.80358 15.8116 -17.6513 -43.1362 -7.7855 -388 1 14.0258 10.1309 4.70784 36.378 -19.982 -23.5474 -389 2 14.2654 9.87929 5.60631 -3.02994 -1.07275 0.485782 -390 2 14.6765 9.60938 4.12831 -34.5421 20.7478 23.7761 -391 1 7.50853 17.298 8.98976 4.28677 22.6193 13.4416 -392 2 7.01472 17.6504 9.76182 0.935323 -12.9311 -15.6818 -393 2 7.87431 18.0869 8.55212 -1.49272 -9.54271 -2.09709 -394 1 4.57424 14.4015 3.77738 -1.32578 6.84514 50.6918 -395 2 4.51443 15.3073 4.2079 4.46262 -31.6709 -20.6737 -396 2 4.58351 13.7394 4.53798 -1.39317 23.0513 -31.5206 -397 1 14.2431 7.32994 15.8885 26.8814 9.55229 5.02737 -398 2 15.048 7.31796 15.3145 -19.1816 0.583054 17.9404 -399 2 14.5184 7.8184 16.7026 -8.00009 -12.2304 -19.9762 -400 1 3.00564 18.4171 1.98737 1.19435 35.3283 33.2576 -401 2 2.60973 17.9491 1.28647 -18.7059 -24.7202 -27.1582 -402 2 2.28625 0.311703 2.39571 15.2164 -11.2621 -13.5372 -403 1 7.97098 1.60459 4.54116 29.2267 3.13781 -13.0843 -404 2 7.39603 1.96083 3.86318 -8.15365 2.40339 -0.697123 -405 2 8.86388 1.74438 4.1564 -17.9094 -5.03071 12.9608 -406 1 2.50155 14.1648 17.7228 -14.4362 -20.2086 14.4505 -407 2 1.80023 13.5192 18.0233 22.5798 22.6486 -13.5864 -408 2 3.34474 13.7188 17.8802 2.38023 -0.79805 1.89101 -409 1 0.962462 1.97628 13.8796 24.0866 5.42438 -18.2963 -410 2 1.23331 1.73159 14.7528 2.00372 -3.67266 20.967 -411 2 0.0219615 1.96156 13.879 -26.3344 -0.788872 -2.58417 -412 1 4.34962 0.156713 13.8729 25.4477 -1.51409 -1.97896 -413 2 5.30295 18.5478 13.9084 -21.2168 3.6137 -4.76321 -414 2 3.99528 18.4902 14.7051 -3.29088 -0.042535 8.53213 -415 1 7.35889 1.01117 18.4602 -20.0845 2.29217 31.534 -416 2 7.53777 0.614221 17.6282 1.02155 -13.8743 -28.1328 -417 2 6.39885 0.929085 18.6632 17.4429 7.83311 -8.37388 -418 1 15.8463 18.3909 13.9448 -43.3072 10.6601 -1.92517 -419 2 14.916 18.6906 13.7723 29.0574 -10.6436 -1.66619 -420 2 15.8257 -0.445507 14.8871 10.2412 6.45473 0.424587 -421 1 10.2808 4.63783 16.2194 -42.4572 -26.934 -19.6441 -422 2 11.2059 4.65809 16.3645 33.0638 0.71496 4.62375 -423 2 10.0964 3.70704 15.9214 4.59595 26.5122 11.6188 -424 1 15.903 17.6519 4.47823 -22.6026 32.3058 18.5214 -425 2 16.5145 18.4189 4.46111 -7.58873 -12.9749 2.84853 -426 2 15.0701 18.0221 4.91498 30.26 -18.095 -22.6862 -427 1 6.91987 17.5654 13.9309 41.5981 2.12242 13.325 -428 2 7.49428 17.7119 14.7497 -22.2257 -6.74767 -31.4029 -429 2 7.56851 17.4237 13.1898 -17.2813 4.26485 21.283 -430 1 13.2143 6.40362 6.52296 -17.8609 -7.45559 2.6451 -431 2 14.0836 6.75111 6.37132 17.2928 3.48546 -1.85822 -432 2 12.8363 6.25317 5.64277 2.90235 4.29902 5.97585 -433 1 7.86013 2.26394 9.49062 -8.36252 -9.46169 -35.4407 -434 2 7.29684 2.1706 10.2513 -11.7917 -0.851936 13.7299 -435 2 7.34714 1.87564 8.72892 15.7155 15.0955 20.8405 -436 1 15.1343 14.8378 13.7575 -15.8142 13.0315 4.83039 -437 2 14.8532 15.0481 14.6708 3.35379 -3.45087 -12.098 -438 2 14.5629 15.3828 13.1802 11.493 -9.40285 7.27009 -439 1 9.38118 8.39884 3.83519 4.0123 -7.74443 -2.87465 -440 2 10.2467 8.83344 3.97294 -13.6344 -10.1795 -2.34121 -441 2 9.51993 7.43201 3.84247 0.270426 14.3255 0.324032 -442 1 17.6982 13.5806 16.4882 -11.1823 29.4115 -15.1875 -443 2 16.7477 13.4163 16.452 -1.16521 -4.14372 2.83933 -444 2 17.7994 14.4458 16.0124 3.95943 -25.1425 10.6502 -445 1 4.93057 10.3937 2.82949 21.3493 0.31084 -7.87351 -446 2 5.82872 10.0425 3.0149 -20.5327 4.11374 3.5741 -447 2 4.70497 10.9363 3.59521 3.63155 -1.89772 -0.291932 -448 1 3.65557 8.40975 9.92882 -7.92631 -13.4411 16.4299 -449 2 3.66668 9.34394 9.72247 1.00161 8.70404 1.26029 -450 2 3.36367 8.33438 10.8592 4.36465 5.8519 -13.4993 -451 1 15.9508 6.91708 5.85912 26.4071 -7.62551 -3.83966 -452 2 16.729 7.34279 6.26867 -14.5536 -3.6129 -4.6023 -453 2 16.2929 6.05819 5.53033 -12.7649 13.2481 9.54942 -454 1 15.2478 7.26488 8.9948 -11.5397 21.0457 -23.7706 -455 2 16.0349 7.57374 9.47019 -5.83 4.16597 -2.61919 -456 2 14.9977 7.92652 8.27445 16.2337 -23.38 28.7542 -457 1 6.17715 12.7863 12.74 7.06624 23.8889 14.8517 -458 2 6.98998 12.4152 13.1111 -3.934 -5.41615 -1.6338 -459 2 6.02064 13.6181 13.2483 1.6805 -16.267 -10.1818 -460 1 12.1255 4.53395 13.1266 36.5984 28.8141 18.352 -461 2 12.1988 4.68857 14.088 4.72218 -0.985297 -9.83354 -462 2 11.344 4.04995 13.0228 -42.0246 -23.4808 -8.79261 -463 1 11.4542 8.08345 7.86287 23.2187 -10.867 14.4494 -464 2 12.2022 7.55078 7.50013 -20.6002 10.1652 -0.104446 -465 2 11.6749 8.16233 8.821 -5.77941 1.62242 -23.2927 -466 1 16.9966 10.8 7.60022 14.0465 -17.3895 -10.8701 -467 2 17.6655 10.1188 7.31004 -18.6815 22.6831 6.1404 -468 2 16.8855 11.476 6.90625 3.56282 -12.242 0.823841 -469 1 5.28409 18.0615 10.7272 -25.4136 -4.73004 -4.09376 -470 2 4.85025 17.4105 11.3211 10.0924 14.2936 -14.0097 -471 2 4.61921 18.235 10.0106 18.3134 -6.11244 18.1083 -472 1 7.63344 17.4775 1.60819 -12.3126 -2.35291 35.094 -473 2 8.06049 16.702 1.26786 10.3266 -12.472 -14.3961 -474 2 7.64482 18.174 0.971148 2.96613 14.6858 -21.2308 -475 1 1.92556 12.9088 13.6099 -6.92879 6.84011 17.0322 -476 2 1.40166 12.3078 14.1747 6.51182 9.66465 -5.96466 -477 2 2.01688 13.7519 14.1152 3.80073 -20.221 -11.3532 -478 1 9.32296 6.74742 14.7603 -6.16505 19.9578 -6.21839 -479 2 9.80961 6.04203 15.1542 10.8193 -23.4577 14.2182 -480 2 9.81429 6.97553 13.9666 -4.58884 0.0213979 -5.59057 -481 1 15.2687 4.29028 10.7744 -16.6773 -11.1812 -9.87371 -482 2 16.185 4.03181 10.6852 9.89086 1.55812 4.86514 -483 2 15.2046 4.88146 11.5266 6.28069 5.56792 1.9642 -484 1 11.3833 6.23863 0.0689293 -3.19885 -6.29427 4.65322 -485 2 11.5449 5.27036 18.7473 -10.1654 17.1623 -6.02864 -486 2 10.4171 6.41156 18.6664 16.019 -11.974 -2.10863 -487 1 18.4779 11.4738 14.9298 -4.11302 6.12113 -30.5228 -488 2 18.0937 12.0014 14.1715 8.36132 -18.8326 26.0479 -489 2 18.3027 12.0103 15.7035 0.536699 7.83234 4.13522 -490 1 7.03799 9.27423 7.33397 -11.8444 -18.9096 15.35 -491 2 6.61404 8.50211 7.787 12.2323 17.6714 -16.3801 -492 2 7.97664 9.07639 7.31215 4.33333 -2.45816 -2.54611 -493 1 18.3885 15.3347 12.1965 11.3664 3.9942 -3.56245 -494 2 0.676524 15.5664 11.9851 -14.9026 2.39255 4.26485 -495 2 17.8062 15.8491 11.6143 4.55299 -1.04774 1.98359 -496 1 16.551 4.342 5.30396 -29.3567 -2.30965 40.8017 -497 2 16.5003 4.35995 6.30392 8.99046 -4.55546 -31.3189 -498 2 17.4312 4.58446 5.06774 26.2551 1.0485 -9.7407 -499 1 17.7614 3.18175 10.7726 14.454 -1.68376 5.55906 -500 2 18.6848 3.25815 11.0867 -17.2868 6.635 -4.74284 -501 2 17.731 2.30667 10.3896 -4.78084 -7.5669 -7.23363 -502 1 12.3288 18.6185 10.0887 4.81564 48.0444 9.66027 -503 2 11.5224 0.4701 10.402 18.5752 -22.9317 -12.6203 -504 2 13.04 0.683861 10.1001 -20.831 -28.6711 -0.571217 -505 1 10.4023 9.75891 12.5069 9.56908 10.7357 22.5843 -506 2 11.0968 9.84844 13.1991 -9.82495 1.00858 -15.0243 -507 2 10.3005 8.81694 12.4067 -0.389825 -11.0581 -5.16736 -508 1 0.728244 2.62509 7.20528 10.511 21.9286 8.67284 -509 2 1.10851 3.44304 7.59367 -9.47208 -14.047 -5.98037 -510 2 0.946108 1.9669 7.86838 0.119732 -6.07738 -1.41007 -511 1 0.301432 15.3195 6.88989 15.9737 -48.0831 -14.5816 -512 2 0.502768 15.5752 7.7858 2.08568 -2.79341 12.7124 -513 2 0.620951 14.3521 6.81024 -17.8336 49.2232 -1.9498 -514 1 17.0496 6.91172 14.9593 8.8057 -4.67917 1.70395 -515 2 17.812 7.50707 14.8676 -6.01141 -3.19386 0.836122 -516 2 17.3983 6.09137 15.355 -4.50622 8.29661 -2.9861 -517 1 9.11865 12.5108 8.02933 -49.9881 -7.42173 -16.2711 -518 2 9.47674 11.8107 7.47486 8.95817 -5.21768 -2.38673 -519 2 8.15231 12.5395 7.74329 38.6911 2.79466 15.4325 -520 1 1.1334 1.67756 2.81686 3.27117 15.7614 -6.58164 -521 2 0.957986 2.31477 2.10151 -6.66947 -14.3695 3.78127 -522 2 1.78538 2.12055 3.36586 -0.578909 1.22693 6.40118 -523 1 4.20106 15.0562 10.0364 -13.4085 1.18971 -5.18923 -524 2 3.93003 15.0868 9.10675 3.70212 3.27773 4.96515 -525 2 5.05647 14.6363 10.0432 10.3336 -3.36269 -1.32379 -526 1 7.40784 2.22679 14.822 -4.38879 4.63456 3.27925 -527 2 7.05629 1.62422 14.1639 1.19517 -1.6595 -3.72526 -528 2 7.83793 2.94849 14.3413 -6.72155 -4.85002 1.32971 -529 1 18.3301 14.5327 2.1542 24.8671 -25.4621 4.78212 -530 2 0.57397 14.7195 2.50861 -8.4973 4.51839 -6.64425 -531 2 17.8578 15.3422 2.05909 -12.5294 22.9533 -1.13776 -532 1 10.0489 2.71902 12.9028 6.85621 -14.8278 -12.6664 -533 2 9.96638 2.08865 12.1549 1.47254 10.1846 11.5218 -534 2 9.24995 3.25129 12.8895 -2.74325 3.95657 -0.856162 -535 1 2.95855 8.84401 12.9769 -19.5266 -12.9618 -2.46154 -536 2 3.45638 9.64099 12.8192 4.11354 12.8609 -3.4499 -537 2 3.6113 8.17746 13.175 10.7686 -6.78904 5.39462 -538 1 3.18595 8.60313 3.78164 6.49512 -8.67182 57.5105 -539 2 3.58728 9.20701 3.1814 16.1034 15.9636 -13.6327 -540 2 3.51933 8.8716 4.70776 -18.429 -13.2453 -44.8458 -541 1 5.73851 7.25721 8.5964 -4.13987 -1.96532 11.6754 -542 2 5.69005 6.29369 8.53393 1.30439 2.87011 -1.70973 -543 2 5.04632 7.51192 9.22575 1.66035 -1.11756 -5.95213 -544 1 14.9081 1.62503 1.83745 -8.73365 -28.3512 -14.8102 -545 2 15.1675 2.29904 2.4498 2.46531 19.8996 4.15138 -546 2 15.1848 1.81402 0.924567 6.2551 4.83326 15.3454 -547 1 8.63912 15.0489 0.67096 1.85438 -3.84451 5.87273 -548 2 9.43742 14.948 1.21756 -6.6173 4.03251 -1.68679 -549 2 7.96284 14.4978 1.10066 2.22069 5.93818 -4.9944 -550 1 15.4364 1.44293 7.19944 -29.9197 -3.33934 -17.0244 -551 2 14.7125 0.994492 6.68707 24.0317 7.87524 16.0302 -552 2 15.0797 2.33705 7.33252 4.46076 -6.95989 4.74521 -553 1 4.93029 12.8913 18.4644 10.9792 1.21933 18.1223 -554 2 5.27563 12.987 0.740174 -6.01723 -1.47567 -19.726 -555 2 5.68015 13.1369 17.9044 -5.07302 3.16897 2.74711 -556 1 15.3923 8.68146 18.054 15.694 19.9465 -16.5309 -557 2 15.9315 9.21769 17.4147 -18.0717 -17.5644 15.7946 -558 2 15.1857 9.29971 0.121687 -1.56315 -2.75746 2.59172 -559 1 11.9784 3.14039 18.3403 11.1408 -7.29272 18.8649 -560 2 12.1001 2.9975 0.653392 -4.70819 -0.503108 -12.7749 -561 2 12.4778 2.40933 17.9385 -7.35096 7.48199 -3.86664 -562 1 13.1896 12.7267 5.18606 4.81883 -3.59528 0.0329893 -563 2 13.4958 11.8346 4.97314 2.3467 3.28367 -0.068752 -564 2 13.4618 12.8881 6.09814 -4.13789 -2.12194 -0.520265 -565 1 6.18108 7.13483 0.245639 -8.98659 -24.3205 -5.24363 -566 2 6.15368 8.0627 19.0493 5.02048 26.2765 -0.395042 -567 2 5.28324 6.84248 0.444666 1.40419 -2.69741 2.9636 -568 1 17.7469 15.8806 14.9091 -16.6307 4.82259 1.60218 -569 2 16.7811 16.0196 14.9781 16.1488 -1.66255 -6.01934 -570 2 17.9228 15.7652 13.9648 -0.217809 -0.705292 2.49903 -571 1 13.1074 0.925484 16.7107 3.18003 -6.63181 9.52558 -572 2 14.0398 0.701227 16.9047 -10.9319 3.14101 -7.94235 -573 2 12.6435 0.0729893 16.6565 6.11054 4.53406 -2.82687 -574 1 10.8779 14.5049 7.42771 23.1657 22.4115 -16.2389 -575 2 10.1426 13.9786 7.6854 -20.2069 -15.6201 11.4355 -576 2 11.6544 13.9411 7.50544 0.873985 -2.97227 1.69423 -577 1 17.7332 8.41688 2.16357 9.83329 25.3003 13.1733 -578 2 16.8474 8.49196 2.51389 -11.5025 -5.56634 1.51969 -579 2 17.684 7.86174 1.40275 -6.79002 -17.3841 -17.6814 -580 1 12.5241 7.78132 2.0423 -1.44154 17.0415 -14.1456 -581 2 12.3356 8.69211 1.74465 0.56853 -10.9135 10.1338 -582 2 12.0507 7.22418 1.41137 4.13261 -1.84431 -3.3422 -583 1 12.0402 14.5123 10.5082 -18.3289 -2.04433 -49.0296 -584 2 12.3885 14.3833 9.58045 -11.5085 2.39427 35.0464 -585 2 11.0712 14.6752 10.3612 24.5139 -2.29095 9.58119 -586 1 6.7433 6.75035 15.5111 8.69017 25.9379 21.8943 -587 2 7.64047 7.11596 15.2998 -22.3365 -16.355 4.27733 -588 2 6.42641 7.26782 16.2896 9.37622 -14.6905 -17.8302 -589 1 7.9604 4.42511 13.2728 28.7823 16.7879 24.018 -590 2 7.37747 4.63038 12.5661 -23.4436 4.48442 -18.6585 -591 2 8.25373 5.30295 13.5968 -1.99494 -17.578 -1.9241 -592 1 13.2943 12.2257 14.4027 3.56556 -5.33332 1.41443 -593 2 13.2861 11.2546 14.3815 -5.78887 6.10336 -0.82645 -594 2 13.6298 12.4878 13.5348 -0.194802 0.853385 3.24808 -595 1 14.4975 9.60743 7.32851 -1.81828 -22.5371 -11.9494 -596 2 15.283 10.0905 7.53237 20.8949 12.3364 4.94663 -597 2 13.7862 10.0745 7.73482 -16.3884 10.3496 13.6544 -598 1 12.6855 16.7955 3.35468 10.446 54.0378 -9.24021 -599 2 12.8247 17.4169 4.11373 -2.43161 -22.9959 -18.5255 -600 2 12.7287 17.4093 2.56008 -5.07923 -25.2307 27.5772 -601 1 0.985851 7.00227 17.3383 1.31889 9.4813 -6.51378 -602 2 0.174673 6.82729 17.8428 -2.72668 6.21708 -7.63644 -603 2 0.788987 7.63656 16.6124 1.43967 -10.9643 14.4702 -604 1 12.9703 4.85252 15.7444 36.7131 7.67865 -11.6648 -605 2 13.7444 4.28338 15.4912 -28.1266 12.6425 14.7219 -606 2 13.3848 5.73698 15.8318 -12.3641 -9.92719 -0.136909 -607 1 2.31739 3.41657 5.06312 -13.6796 12.8802 45.0615 -608 2 1.71742 3.03519 5.77756 22.5616 7.27981 -29.9715 -609 2 2.67638 4.25091 5.49055 -8.69432 -27.9074 -22.1065 -610 1 8.14626 10.9014 13.7501 23.1519 -21.2188 51.9658 -611 2 8.18961 10.6456 14.7569 -3.14293 16.1916 -66.8861 -612 2 8.91613 10.442 13.3487 -9.38929 12.2654 3.7561 -613 1 12.9965 1.57692 13.2293 -13.236 30.2614 -33.2276 -614 2 13.5053 1.61767 12.3799 -8.92772 -10.8244 27.0208 -615 2 12.3556 2.33631 13.1194 22.5086 -26.9187 11.5847 -616 1 6.63966 13.684 2.03193 -11.5531 1.65982 24.7971 -617 2 6.01437 14.0711 2.69678 13.9712 -7.1585 -19.9778 -618 2 7.21702 13.1132 2.57076 -4.92077 5.61769 -6.96253 -619 1 15.813 6.37449 12.4855 -26.0384 -19.2076 5.56376 -620 2 16.3133 6.94665 11.9354 17.458 16.492 -16.919 -621 2 16.1081 6.5465 13.3734 10.1637 1.50607 12.5345 -622 1 16.7517 0.683836 9.54032 9.17465 -17.8268 3.86543 -623 2 16.8312 18.3701 9.76674 -11.2714 16.7378 -3.92594 -624 2 16.3182 0.76443 8.67683 0.0107679 -1.03064 0.242674 -625 1 6.19528 11.6935 8.23629 -2.98771 -55.3704 13.0415 -626 2 5.39217 11.4329 8.74625 16.1659 14.5788 -12.0119 -627 2 6.59624 10.789 8.03203 -10.8651 41.6219 1.75135 -628 1 2.78257 8.63233 0.349942 -51.0927 -6.02203 -19.4773 -629 2 2.14734 8.16991 18.3384 31.254 20.3071 31.1367 -630 2 2.20011 9.24624 0.868363 16.6862 -13.9373 -14.0055 -631 1 10.0933 10.2699 6.60791 4.69659 2.91801 -6.95173 -632 2 10.6585 9.65933 7.0984 -2.33853 -1.64778 -0.152736 -633 2 10.478 10.3114 5.71024 -7.38541 0.394324 12.3102 -634 1 6.85971 15.7454 6.78123 4.24276 8.06212 3.90305 -635 2 7.14611 16.2575 7.56121 -6.95129 -7.98507 -8.49325 -636 2 7.04221 16.3283 6.02778 -2.00154 -5.2395 1.03704 -637 1 6.5672 12.9167 5.89107 0.597921 -4.77378 -3.41809 -638 2 6.75629 13.7931 6.22612 0.282518 9.70238 2.49815 -639 2 6.16516 12.4266 6.61937 1.75727 3.9196 -1.62353 -640 1 16.7395 12.5246 9.74847 -3.06854 -10.3396 -13.3378 -641 2 16.803 11.7934 9.09918 0.0574675 11.3505 13.7779 -642 2 17.2471 13.2388 9.35461 0.0307086 0.265441 4.69208 -643 1 6.27963 2.83254 2.76143 -4.73524 -28.0523 14.6006 -644 2 6.37898 3.73989 2.5277 5.16678 22.951 -10.7112 -645 2 5.79937 2.39077 2.0523 -0.657158 4.14199 -3.99187 -646 1 10.6834 2.9997 3.2493 -4.30343 6.66703 3.45031 -647 2 10.3389 3.87773 3.47337 -2.10815 -7.43082 -2.74741 -648 2 10.1644 2.67816 2.50044 1.52937 0.706493 -1.87803 -ITEM: TIMESTEP -100 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.77244 6.59569 17.9763 -3.45079 -15.6041 -9.13306 -2 2 7.88004 6.49722 18.3444 6.65526 3.83231 -3.73646 -3 2 8.88832 5.875 17.3232 0.339998 10.7344 11.2284 -4 1 0.232197 8.43163 6.74931 6.06809 -9.75314 40.4456 -5 2 0.255717 8.25928 5.82997 0.568886 -7.03857 -37.2819 -6 2 0.690537 7.6579 7.15764 -12.6716 20.3857 -3.7924 -7 1 8.73054 0.448274 6.96197 0.757688 5.19807 -2.99354 -8 2 9.64384 0.493158 6.62895 -11.5479 0.592924 -0.0248858 -9 2 8.1978 0.998025 6.35807 9.15448 -7.13553 5.61176 -10 1 6.40593 1.75267 11.8149 38.8296 -3.08614 -8.28972 -11 2 5.81968 2.38515 12.1727 -25.8813 19.5399 13.38 -12 2 5.91601 0.958217 11.6787 -14.9693 -21.4487 -5.83463 -13 1 6.93553 5.46707 2.3717 -29.4847 3.29264 10.9289 -14 2 6.2293 5.77948 3.0367 33.3819 -5.43232 -34.2308 -15 2 6.73101 5.82483 1.47662 0.276644 1.33511 28.97 -16 1 16.2706 10.1725 16.0328 16.576 -12.0275 -13.9735 -17 2 17.1689 10.3287 15.6909 -13.6837 1.56601 5.28727 -18 2 15.9002 11.0264 16.2303 -5.40144 13.1923 2.47446 -19 1 10.8573 14.9713 2.3127 -4.53536 -0.807355 -13.4682 -20 2 10.8458 14.5197 3.15612 -3.95698 -5.41896 6.20362 -21 2 11.2908 15.8056 2.48855 3.23834 4.77246 6.19277 -22 1 17.2232 8.21136 11.0033 2.73792 2.45641 -7.11401 -23 2 16.6726 8.88418 11.4331 2.86084 -2.93597 -0.581414 -24 2 17.9525 8.69866 10.5809 -6.6523 -2.55116 4.88578 -25 1 14.5937 16.0509 16.2923 16.8919 1.55785 -12.0612 -26 2 13.6919 16.3738 16.3176 -7.99874 0.738503 2.77307 -27 2 14.7362 15.4806 17.0483 -6.38665 -4.70858 10.3974 -28 1 12.1782 13.2488 0.556058 -6.41896 9.17153 -4.9038 -29 2 11.8393 13.4134 18.3136 3.64438 -6.73296 -6.87976 -30 2 11.6781 13.8768 1.08938 4.30308 -0.940018 9.70193 -31 1 9.32636 5.50189 3.85673 -23.6707 -6.9557 11.6523 -32 2 8.85207 5.35955 4.73387 10.6863 3.91607 -36.7024 -33 2 8.65492 5.41152 3.1282 11.356 3.18621 25.5004 -34 1 1.53424 3.89903 11.544 -4.66799 23.5976 14.1629 -35 2 1.33558 4.79151 11.9229 9.77101 -18.0042 -9.49869 -36 2 1.78943 3.33535 12.2834 2.68741 0.460061 1.88957 -37 1 2.11036 6.99869 8.11066 2.48315 -17.2899 2.96853 -38 2 2.57184 7.49315 8.78305 3.29023 12.1045 5.89357 -39 2 2.1177 6.10606 8.48449 -3.4025 -1.3508 -8.01694 -40 1 5.18347 4.46977 7.78792 -2.57538 4.03359 -5.12796 -41 2 5.37117 3.51932 7.65443 -4.82345 11.4027 -0.558597 -42 2 4.53495 4.79047 7.12216 11.4175 -13.4448 8.55636 -43 1 3.42716 2.88114 17.3924 1.12201 37.8538 -2.09818 -44 2 4.03218 3.21565 16.6954 -8.80258 -2.8612 13.6459 -45 2 2.96175 3.68375 17.7714 12.3959 -28.5801 -12.8282 -46 1 7.56049 5.45137 6.19682 -11.2764 11.7759 39.3451 -47 2 8.17338 6.02323 6.733 -17.9712 -15.9787 -15.2388 -48 2 6.83707 5.19934 6.84169 25.8687 -1.03041 -23.6459 -49 1 9.81873 7.03274 12.0818 18.6926 1.80354 21.1658 -50 2 10.1168 6.17447 11.801 2.37707 -8.57843 -5.75387 -51 2 9.13705 7.28384 11.4839 -21.9155 5.9942 -18.2818 -52 1 13.9782 3.81734 8.11005 -6.38125 -7.14222 -11.0636 -53 2 13.4268 4.53125 7.77431 4.97705 1.71109 -4.47031 -54 2 14.3288 4.12395 8.93436 6.50574 7.00298 17.9277 -55 1 4.54162 17.1358 3.87887 10.9044 35.7056 -0.341992 -56 2 5.36932 17.5648 4.19271 -11.2647 -17.0231 -6.60056 -57 2 4.14672 17.8103 3.27983 -0.0256371 -21.9717 9.98561 -58 1 16.2123 16.5489 10.6095 26.1835 -5.76397 -19.4616 -59 2 15.4589 16.7003 11.1416 -23.8325 7.35421 23.2226 -60 2 15.8886 15.8767 10.0022 2.98718 1.98497 -7.14015 -61 1 1.93449 4.79928 0.00082377 17.3961 -4.98991 5.57961 -62 2 2.67896 5.07161 0.592242 -22.0191 7.26131 -10.4701 -63 2 1.68005 5.53286 18.0583 5.78187 -2.17332 10.5029 -64 1 11.1761 13.3033 16.4476 20.6858 -29.5101 -20.5449 -65 2 10.7502 12.4348 16.5818 -0.505604 15.8506 2.04497 -66 2 11.8189 13.0874 15.7254 -14.483 14.0049 15.9552 -67 1 10.0082 10.9133 16.7377 -9.76065 -12.5647 6.43928 -68 2 10.4104 10.0696 17.0143 -3.0625 14.8211 -5.5238 -69 2 9.04798 10.758 16.6751 14.6534 4.77532 0.819581 -70 1 11.8926 17.5507 13.5059 -15.5524 -14.4544 -0.25773 -71 2 12.4585 17.1847 12.8152 4.41482 5.53476 3.60851 -72 2 11.9755 18.5016 13.5139 9.00416 11.9454 -7.12981 -73 1 6.39659 9.54323 12.3526 -12.6063 6.46711 4.93213 -74 2 6.97402 9.29797 11.635 9.25294 -5.21247 -6.5221 -75 2 6.9248 10.0607 12.9773 -1.49192 -5.83682 -8.37915 -76 1 16.2827 12.8664 2.8283 0.430065 -24.2056 0.300325 -77 2 17.1271 13.2094 2.55074 10.9303 3.80489 0.0707423 -78 2 15.7284 13.6342 2.87288 -15.0446 12.1841 2.12753 -79 1 0.782434 12.8185 5.85612 -33.4557 3.27495 -26.778 -80 2 1.12737 12.9122 4.94214 -3.16706 -8.15793 13.9432 -81 2 18.4302 12.7528 5.74133 33.3816 -1.67566 5.80796 -82 1 5.29416 16.3645 18.462 -0.365113 -1.85929 1.37874 -83 2 5.65117 15.5929 17.9841 -1.41418 12.24 9.00358 -84 2 5.90904 16.5787 0.535619 -2.78951 -3.81837 -4.76209 -85 1 0.717617 7.68269 4.16298 45.78 12.5398 -25.9452 -86 2 0.140595 7.95484 3.42088 10.68 -3.85526 14.32 -87 2 1.67421 7.98176 3.89702 -61.12 -15.169 17.2669 -88 1 3.20538 9.16537 6.53153 -16.7997 -26.3462 11.633 -89 2 3.63886 8.66012 7.25517 -10.7634 14.1338 -16.8685 -90 2 2.28456 8.785 6.4428 29.8979 17.6904 5.8263 -91 1 7.3492 10.4558 16.1821 -32.1717 -5.51262 30.2531 -92 2 6.6595 11.1272 16.0448 13.9154 -6.26319 -1.99334 -93 2 7.03952 9.99344 16.9918 7.69449 10.9592 -10.5833 -94 1 10.9926 0.857119 5.02234 -5.32556 5.69944 -21.4369 -95 2 11.0071 1.72344 4.58448 5.20867 -2.07691 11.6276 -96 2 10.6449 0.320945 4.28448 4.96755 -3.65716 14.4683 -97 1 4.17972 2.99732 13.1563 8.08367 -30.8511 5.02994 -98 2 4.53886 3.3528 13.9956 -8.94088 -10.2248 -10.148 -99 2 4.12323 1.98418 13.2207 2.50903 42.0947 6.54014 -100 1 8.52337 10.2728 1.80778 10.3789 -10.908 24.8689 -101 2 8.43412 10.9106 2.54849 -2.4679 -8.46295 -11.8092 -102 2 8.72683 9.4118 2.24878 -4.48166 20.4458 -7.62428 -103 1 10.3146 1.66303 15.4651 0.0280032 6.46587 3.16016 -104 2 11.2365 1.5769 15.7049 7.71736 -2.87845 -0.628854 -105 2 10.2832 2.03916 14.5766 -0.873711 -2.30994 -1.44208 -106 1 2.60872 12.9688 7.93078 -1.0685 2.90827 1.70102 -107 2 3.08524 13.7852 7.70925 1.81136 -8.54773 -5.41906 -108 2 2.07592 12.7429 7.1537 2.1601 3.22826 4.8584 -109 1 3.84139 11.714 4.98357 -9.2182 -6.48315 2.00023 -110 2 3.59649 11.1336 5.73363 3.13206 7.92599 -15.0555 -111 2 3.08391 11.75 4.36582 7.48234 -0.753218 11.1676 -112 1 6.65636 14.539 16.9808 1.14971 -3.74934 -0.345026 -113 2 7.45699 15.0461 17.1534 0.734042 -3.82079 -1.22553 -114 2 6.35462 14.7758 16.0963 4.10604 -0.420587 -1.60546 -115 1 14.2186 14.4753 3.18712 8.31434 -1.03143 -11.3814 -116 2 13.7635 15.2982 3.34662 -3.59872 10.6386 -1.06184 -117 2 13.8465 13.8568 3.80574 -6.38377 -9.35153 11.7656 -118 1 8.76639 18.036 16.1575 -17.2352 -7.71273 4.18589 -119 2 9.29865 17.253 16.446 -1.99578 26.3863 -16.3924 -120 2 9.21082 0.13577 15.7005 10.7734 -16.3176 12.3305 -121 1 4.70057 1.84937 4.90583 -5.59427 22.8387 -36.2464 -122 2 3.793 2.25175 4.86575 28.8401 -10.2604 4.23254 -123 2 5.1801 2.18711 4.08016 -18.9233 -12.3263 38.2061 -124 1 15.0501 12.6021 16.5687 -12.0311 0.26828 5.88874 -125 2 14.6786 12.8761 17.4109 9.53333 3.55003 6.01908 -126 2 14.2645 12.5148 16.0221 4.98358 -1.43573 -15.5641 -127 1 15.7004 18.5129 16.8573 39.713 -3.42746 23.3516 -128 2 16.4681 18.7143 17.5055 -38.5977 -15.0096 -30.817 -129 2 15.6109 17.5396 16.7903 -2.54574 14.9499 6.02131 -130 1 1.36802 1.35817 16.6529 -7.19601 7.74866 13.6684 -131 2 2.15913 1.86948 16.876 -3.57304 -8.28302 -6.01627 -132 2 0.751389 1.61649 17.3659 4.93092 -7.13328 -12.7379 -133 1 18.2443 4.33431 15.8699 4.87602 -2.4936 -15.9817 -134 2 17.8369 3.63124 15.3424 2.32992 6.4949 4.25729 -135 2 0.452078 4.51482 15.4394 -9.42811 -2.49011 8.2103 -136 1 12.0529 17.1173 16.1421 -28.5646 -13.5401 15.8604 -137 2 11.3287 16.6705 16.6559 24.6179 11.2855 -13.6919 -138 2 11.708 17.1501 15.239 10.7504 0.848438 1.34073 -139 1 16.0751 2.69533 18.2299 -16.8426 22.7601 -19.9608 -140 2 15.7518 3.52741 18.6545 8.16925 -19.768 -14.2608 -141 2 15.768 2.75869 17.2894 6.47211 -5.43997 24.4047 -142 1 6.70105 13.7211 10.0493 -2.92253 -3.29615 13.924 -143 2 6.49616 13.3451 10.9223 2.46715 2.87816 -3.90822 -144 2 6.5701 13.0016 9.42848 5.58743 -2.71244 -4.10916 -145 1 10.1642 18.4563 2.66846 -6.4553 9.35236 -16.0973 -146 2 10.4494 0.522706 2.05557 -0.598662 -14.7868 7.93587 -147 2 9.23943 18.2921 2.43567 5.35466 0.524311 4.08806 -148 1 3.08905 17.6286 6.23363 28.1073 -1.15148 23.9606 -149 2 2.19758 17.5876 5.91536 -10.6529 4.22104 -18.8026 -150 2 3.7136 17.7221 5.50184 -12.297 -3.14114 -7.6924 -151 1 12.6187 16.7784 7.83399 -8.24743 2.38577 1.37984 -152 2 11.9273 16.0794 7.74003 7.37944 21.7069 5.85683 -153 2 12.3535 17.4638 8.48865 -0.622135 -17.7991 -6.24189 -154 1 14.8741 15.2807 8.33754 11.6667 3.93031 -5.87838 -155 2 14.2607 15.9458 8.0029 -4.6938 -2.09697 8.01324 -156 2 15.5465 15.2244 7.63778 -8.32879 0.363275 5.25782 -157 1 17.8358 18.3077 0.207666 -46.6557 3.82667 -12.4063 -158 2 18.5381 17.6928 0.20107 34.3258 -19.0599 -1.41311 -159 2 18.1099 0.429917 0.68066 12.6369 19.0779 11.4558 -160 1 0.768971 10.519 1.45234 -14.3967 -19.3664 19.1268 -161 2 -0.0407552 10.0454 1.78172 23.5075 9.70284 -14.2764 -162 2 0.503185 11.1892 0.827858 -7.10365 8.12718 -9.46819 -163 1 1.82037 12.3064 3.2607 -0.411525 2.12628 17.6018 -164 2 1.36119 11.682 2.70611 -2.67447 -10.2614 -7.1426 -165 2 2.03731 13.0482 2.69872 0.079619 5.20365 -3.96737 -166 1 0.725717 17.3003 4.98992 32.4002 3.58468 -34.9181 -167 2 -0.000639544 17.8885 5.08952 -19.7566 14.3988 12.6832 -168 2 0.713313 16.5777 5.58791 -15.4184 -21.9192 25.4801 -169 1 0.951486 0.797441 9.37101 14.826 11.188 -16.0996 -170 2 1.14791 0.588384 10.2838 -3.41112 -8.44303 11.2353 -171 2 0.0745467 0.497625 9.13864 -8.88294 -4.64793 9.22513 -172 1 16.8073 2.38946 13.4769 5.39787 -10.4284 -8.99471 -173 2 17.0506 2.69304 12.5747 -8.0967 -7.05722 13.8788 -174 2 16.5161 1.45381 13.4188 4.66162 13.0486 -2.08534 -175 1 2.62912 16.0502 12.0784 8.40953 -12.472 -10.7904 -176 2 3.04385 15.7269 12.8881 -2.37218 0.184289 -5.79457 -177 2 3.10949 15.6337 11.3228 -8.7582 6.42497 16.6586 -178 1 16.3457 15.4302 6.12389 30.9011 24.8554 -18.1041 -179 2 17.2992 15.5349 6.36757 -22.0844 -7.23183 -0.993592 -180 2 16.19 16.1865 5.50068 -1.85714 -20.6143 14.9819 -181 1 5.77873 5.21745 11.785 11.0193 -20.9315 -11.6683 -182 2 5.50793 5.92484 12.3546 -4.36629 16.5013 7.19057 -183 2 5.27867 4.45162 12.0794 -6.37659 -1.59945 -1.70387 -184 1 15.1747 4.94504 0.761547 -29.5175 -4.13494 28.6724 -185 2 14.9952 4.57194 1.67189 6.69018 16.901 -24.5633 -186 2 14.3176 5.30548 0.449447 18.0211 -8.94221 4.63226 -187 1 16.4144 16.461 1.77501 8.34865 -5.69196 -8.65308 -188 2 16.356 16.7636 2.67626 -8.71628 3.92983 13.8981 -189 2 16.7832 17.2073 1.29403 -0.614878 1.7319 -3.63708 -190 1 0.136057 4.8659 3.98965 34.6037 22.2365 -2.60366 -191 2 0.554963 5.79058 3.9624 -19.788 -38.6093 6.27627 -192 2 0.840291 4.21253 4.20207 -10.6708 20.7839 -4.14843 -193 1 2.91044 15.0804 15.1041 7.34684 -10.5058 14.2682 -194 2 2.90482 14.7198 16.034 -7.41786 16.0657 -24.8201 -195 2 2.46761 15.9418 15.099 -2.49045 -2.68752 9.6724 -196 1 0.98952 14.6361 9.40184 3.41519 -3.90395 6.55514 -197 2 1.54705 13.945 9.00075 -6.08548 3.23571 10.1521 -198 2 0.78947 14.3674 10.3125 0.535168 -4.82993 -11.1122 -199 1 13.5676 16.5089 11.5672 -19.673 9.58551 -20.9583 -200 2 13.2883 17.2623 10.9814 5.35041 -18.2182 15.9177 -201 2 13.0352 15.7491 11.2513 9.15027 7.77217 2.32965 -202 1 4.84709 1.60354 0.665871 -13.2454 -7.94988 -14.2061 -203 2 4.37724 2.10746 -0.0295305 4.1335 -5.07179 15.4313 -204 2 4.23428 0.890311 0.93575 7.29231 10.3056 3.49355 -205 1 1.57562 18.6232 11.9448 -9.54215 3.4719 -19.1533 -206 2 1.53947 0.452662 12.7669 0.622104 8.67092 13.3018 -207 2 1.94164 17.7639 12.1401 7.67295 -5.68018 1.31967 -208 1 11.3828 10.0809 4.23132 25.5406 -0.783734 -33.5194 -209 2 11.2477 10.3841 3.29047 7.40472 -5.62792 30.1478 -210 2 12.3604 9.90108 4.31318 -36.068 9.82931 1.34024 -211 1 8.1924 12.225 3.79726 -5.69748 14.5101 56.1678 -212 2 9.05523 12.5573 4.13122 -12.2475 -6.42112 -18.1901 -213 2 7.61811 12.3317 4.63279 18.664 -10.6547 -44.172 -214 1 14.6446 4.04033 3.3856 3.29585 4.20735 14.8065 -215 2 15.1799 4.13354 4.21231 -10.8641 -1.34483 -21.0767 -216 2 13.7289 4.27483 3.60977 8.83721 -0.102893 1.13309 -217 1 5.73789 1.70847 7.633 -45.2268 -33.2589 19.0394 -218 2 5.00558 1.12579 8.07813 40.2552 34.7696 -21.6936 -219 2 5.52319 1.67762 6.69069 2.06189 0.609235 -2.30714 -220 1 17.8554 0.94247 4.83325 2.84508 1.94772 -6.32822 -221 2 18.4375 1.13729 4.06994 -6.68522 3.20321 14.3473 -222 2 17.8361 1.70281 5.4359 2.52705 -5.98387 -7.60558 -223 1 6.82607 9.13014 4.53731 -2.03949 -2.27606 -0.824268 -224 2 6.749 9.37751 5.45829 -4.27203 4.05265 7.19029 -225 2 7.76352 8.95198 4.44117 4.86868 -1.78157 -6.05796 -226 1 2.39805 14.6397 2.05874 17.0918 -1.49078 4.46086 -227 2 3.17145 14.6314 2.66377 -10.8679 0.525641 -12.6634 -228 2 2.72903 14.4183 1.17543 -1.81421 4.03234 5.90777 -229 1 17.1796 12.9575 13.0281 -10.0626 2.91445 0.0973403 -230 2 16.3048 13.3397 13.2675 20.7192 2.62525 -4.36947 -231 2 17.7682 13.6617 12.6978 -15.1419 2.46765 5.43564 -232 1 14.7925 10.5715 1.51204 -8.6843 -36.4521 -19.1925 -233 2 15.3686 11.2103 1.85793 27.186 33.4644 17.5702 -234 2 13.9217 10.9161 1.62765 -18.2001 7.18743 0.677482 -235 1 5.63756 6.65584 4.53835 -5.70194 -14.7917 8.95129 -236 2 5.96892 7.55557 4.50237 4.06113 5.5935 -1.33512 -237 2 6.19689 6.19506 5.18786 2.48768 6.43185 -8.34619 -238 1 8.1035 8.32015 10.3633 -6.06951 -1.51391 13.5103 -239 2 8.71051 8.88696 9.88772 3.75134 6.39998 -5.242 -240 2 7.4427 8.01108 9.7382 -0.891776 -1.59521 -4.95879 -241 1 13.4554 18.4382 5.64567 -23.0826 -2.6609 26.3697 -242 2 12.6541 0.350227 5.51512 12.1971 -9.37205 -2.29397 -243 2 13.2308 17.8847 6.43702 5.12544 9.06169 -21.995 -244 1 0.0481459 2.53289 0.450073 0.762545 20.3906 -8.36614 -245 2 17.7393 2.57826 18.829 23.3906 9.65711 1.86789 -246 2 0.50996 3.41343 0.303855 -21.6669 -27.8541 1.68488 -247 1 12.9745 10.8048 9.65469 -32.5048 41.5261 -13.285 -248 2 12.0083 11.0976 9.65119 33.8953 -25.1931 3.11551 -249 2 13.0333 9.87229 9.85209 -8.8072 -6.07099 4.09073 -250 1 0.527116 12.3319 11.2575 10.4347 -0.622496 2.4881 -251 2 18.2313 12.2915 11.4294 -10.2968 -1.46033 -6.74513 -252 2 0.909084 12.5363 12.117 7.12796 0.366826 -3.41572 -253 1 5.28415 7.34725 13.2845 -6.32664 2.65038 2.55184 -254 2 5.64713 8.17412 12.9655 4.82658 4.12789 -9.57053 -255 2 5.74627 7.2293 14.1116 0.316635 -7.58532 9.69513 -256 1 1.16454 6.74183 12.03 -13.1625 -42.3004 -9.02199 -257 2 0.295417 6.98712 11.7254 -9.09418 5.46945 -3.0829 -258 2 1.57891 7.53521 12.2772 19.8541 36.5775 12.6901 -259 1 15.5783 9.75012 12.4577 9.71681 16.8235 16.5595 -260 2 15.2431 10.6351 12.2158 0.950441 -15.6258 3.07953 -261 2 16.0853 9.89705 13.2804 -12.0519 -4.92211 -13.1427 -262 1 16.5993 12.6285 5.60521 -10.2494 37.6021 -45.7262 -263 2 16.4242 13.6113 5.62967 5.67224 -29.3823 14.3376 -264 2 16.441 12.4706 4.63081 7.92181 -5.25591 31.2114 -265 1 6.41284 9.90681 0.119653 0.515871 -10.7086 -9.9123 -266 2 5.64934 10.3727 0.465056 -3.06655 2.33505 3.46562 -267 2 7.14462 10.1266 0.702846 2.16363 1.41956 4.36049 -268 1 12.2095 5.93838 4.00309 -11.5544 -2.90268 -3.08172 -269 2 12.2942 6.66752 3.37735 2.08742 0.382808 1.33145 -270 2 11.2587 5.74648 4.01779 6.74513 0.670066 1.17813 -271 1 0.342924 12.9268 0.00967172 -2.71894 -2.13654 5.95194 -272 2 18.7348 13.4393 0.793746 3.88983 0.588143 -5.53597 -273 2 18.4589 13.2921 17.9296 1.41778 -5.28425 5.34754 -274 1 3.57599 18.7244 8.67011 -7.57313 7.8026 -17.3863 -275 2 3.53053 18.3214 7.79351 4.94999 -5.98969 2.51912 -276 2 2.6975 0.472694 8.72681 1.72246 -0.921876 11.7862 -277 1 7.19816 17.4543 4.42938 13.0422 27.6578 -13.842 -278 2 7.51541 18.3714 4.6455 -6.70989 -26.1973 -6.43912 -279 2 7.34255 17.3635 3.4592 -3.95356 0.0926602 20.0901 -280 1 9.24276 17.181 12.1874 27.1924 -9.91753 -12.8104 -281 2 9.16544 16.536 11.4403 4.06483 10.4089 22.9332 -282 2 10.1989 17.1789 12.4847 -33.3611 -0.423317 -5.22003 -283 1 13.2427 13.2324 7.99028 -4.63127 -11.2433 10.7708 -284 2 13.2975 12.5097 8.63573 0.309708 1.2863 -7.28868 -285 2 13.9184 13.8596 8.25103 7.01778 4.96536 -0.211076 -286 1 14.7706 2.86972 15.5058 12.3246 -20.976 -18.3849 -287 2 14.0341 2.28041 15.2496 10.8751 5.18171 6.07562 -288 2 15.4548 2.72916 14.8136 -15.3015 9.06101 10.4071 -289 1 9.96013 15.6554 16.9624 -0.416257 -4.3558 -3.6035 -290 2 10.3061 14.8055 16.6414 -1.75696 6.53817 2.71112 -291 2 9.61308 15.4752 17.8389 -3.07369 -3.40172 1.73448 -292 1 11.2206 8.54091 16.6271 11.2119 0.246209 -0.153837 -293 2 10.3853 8.13843 16.425 -12.7378 -7.75768 -8.20822 -294 2 11.7159 7.85532 17.0695 3.92811 -4.5145 7.83184 -295 1 4.19128 18.3534 16.7936 -2.0541 -15.6573 2.75359 -296 2 4.49896 17.6946 17.4386 1.3239 2.14246 -6.87061 -297 2 4.3476 0.553135 17.2025 -0.294224 9.43754 2.6314 -298 1 2.38271 4.321 8.90759 20.0465 -16.3105 29.2362 -299 2 3.33364 4.03277 8.87737 -27.5446 13.4253 -3.78204 -300 2 2.08958 4.1083 9.83354 7.71669 6.29647 -26.7475 -301 1 9.9842 10.4369 9.88352 -17.0195 21.6351 -0.0387615 -302 2 9.44133 11.1731 9.47934 17.4922 -21.0458 18.4718 -303 2 9.94225 10.4854 10.8652 2.27572 1.94662 -18.6097 -304 1 9.85899 0.920399 10.8075 0.162278 -2.63975 1.09763 -305 2 9.48302 0.0750215 11.0855 -2.58178 2.3482 3.77053 -306 2 9.21377 1.33985 10.2254 -0.0206645 -1.54215 -2.59695 -307 1 9.16055 15.229 10.2075 -19.4407 -6.65372 -14.862 -308 2 8.92137 15.8821 9.51239 -0.317996 -13.1788 14.0466 -309 2 8.43697 14.5477 10.1944 18.1534 21.6077 -0.815821 -310 1 0.71674 9.75329 10.1461 2.10813 23.2969 8.50765 -311 2 0.819344 10.7283 10.3167 -3.94998 -28.3852 -4.44668 -312 2 1.15296 9.53542 9.32246 0.728257 4.55427 -3.87479 -313 1 17.2456 4.88922 8.01698 -15.6269 -0.477795 25.7007 -314 2 16.4423 5.19943 8.52213 28.7194 -9.29348 -15.89 -315 2 17.7804 4.31587 8.60398 -15.5446 9.64156 -7.98894 -316 1 14.822 14.6129 0.044879 1.26259 -7.26488 27.1569 -317 2 15.5503 14.8635 0.654609 -16.5042 1.70925 -13.2775 -318 2 14.1019 14.3181 0.644441 11.2495 5.19015 -13.4399 -319 1 3.93398 11.151 9.56657 -13.0999 1.1143 6.92396 -320 2 3.8819 11.1389 10.5379 -0.108421 8.58768 -6.25849 -321 2 3.2885 11.8101 9.24754 8.95434 -7.44407 0.420275 -322 1 11.481 10.7372 1.49136 -12.2308 11.5287 -6.19882 -323 2 11.6479 11.6347 1.11375 -3.03535 -20.3842 8.82813 -324 2 10.5208 10.5745 1.38561 13.1816 3.92224 -1.496 -325 1 13.1382 7.21836 12.5396 -14.3564 7.08975 0.177427 -326 2 14.0771 7.12045 12.4061 13.875 -7.92794 3.07029 -327 2 12.7619 6.3345 12.5945 1.25366 -4.42296 3.81153 -328 1 9.68698 1.99848 0.824055 10.3256 0.727137 24.2023 -329 2 8.81917 1.78721 0.50968 -15.0497 -1.62599 -5.65 -330 2 10.155 2.38703 0.0980655 8.32187 5.69202 -13.7925 -331 1 10.602 13.3929 4.55586 17.4753 0.473987 25.0493 -332 2 11.4671 12.9458 4.66597 -13.9744 4.33191 -5.6004 -333 2 10.4831 13.8198 5.42698 -1.33045 -1.26907 -13.5894 -334 1 14.5505 1.55995 10.9504 0.793491 3.39408 -6.18689 -335 2 15.3506 1.17936 10.5364 -11.0229 12.1378 4.59402 -336 2 14.5582 2.53024 10.8225 7.4254 -12.0179 1.55597 -337 1 14.4508 12.0407 11.6074 10.4267 -5.99888 -36.1251 -338 2 15.2905 12.2256 11.0848 -31.5625 -1.98982 15.431 -339 2 13.8033 11.6041 10.9773 26.0423 16.8772 21.3357 -340 1 8.16091 5.15464 9.81808 -31.1733 -3.04727 19.1057 -341 2 7.28259 5.21015 10.2725 23.9466 4.77499 -10.0641 -342 2 8.23945 4.21356 9.63446 4.25293 -1.90524 -4.29988 -343 1 1.57078 16.9857 18.5145 2.11582 4.65495 -1.34384 -344 2 1.81738 17.3492 17.6562 0.32294 -2.46744 1.69741 -345 2 1.87051 16.0745 18.5076 0.982883 -4.60963 -1.80737 -346 1 1.40224 17.4231 15.3612 30.835 -28.8708 -16.9337 -347 2 1.58171 18.2262 15.8024 1.01568 35.607 16.5514 -348 2 0.474852 17.284 15.3634 -28.8421 -6.17683 0.802216 -349 1 3.44554 5.70547 6.04619 4.62282 22.475 -0.524537 -350 2 3.1428 6.44974 6.61309 0.90031 -17.6364 -10.4242 -351 2 4.06586 6.09018 5.39907 -5.11167 -0.757253 7.03456 -352 1 12.635 9.5385 14.2471 10.4135 -57.691 -2.75625 -353 2 13.0561 8.75521 13.7543 -17.7171 41.3381 15.7803 -354 2 12.3533 9.10151 15.082 0.88858 17.3566 -13.7461 -355 1 4.11217 15.1814 7.19429 24.0597 14.9458 -6.20919 -356 2 3.65166 15.9525 6.80506 8.00815 -8.18076 7.53786 -357 2 5.09537 15.3539 7.08579 -34.9804 -3.92885 1.78443 -358 1 0.830872 8.84313 15.1657 1.50937 4.0339 -6.81168 -359 2 0.547306 9.77972 15.0966 9.11455 -14.6477 -1.64448 -360 2 1.6109 8.72602 14.589 -11.0561 6.95599 3.23137 -361 1 12.8981 8.26079 10.0923 10.5692 -21.7103 -4.02448 -362 2 13.6229 7.70102 9.77244 -0.136865 10.7899 -7.02632 -363 2 12.7945 7.93077 10.9815 -6.52785 3.68747 11.7154 -364 1 15.1981 8.09018 3.38532 -13.0459 -52.6521 2.11346 -365 2 14.5247 7.61376 2.86907 3.36606 26.685 -8.7616 -366 2 15.3386 7.39586 4.05885 15.5852 26.7124 4.01456 -367 1 17.1365 6.7605 0.0284285 -19.4133 2.32297 -2.08842 -368 2 16.6422 5.96523 0.300426 11.1165 9.80228 -2.81184 -369 2 16.4267 7.37993 18.3943 16.5678 -7.00446 5.84521 -370 1 8.97527 7.00353 7.90402 -12.8517 -1.3564 7.9131 -371 2 9.8962 7.25242 7.83012 8.98921 2.98997 4.36252 -372 2 8.82463 6.62979 8.79874 5.5237 0.780274 -18.1173 -373 1 12.5342 0.599732 1.22272 7.37234 -11.2249 5.10795 -374 2 13.3221 0.863275 1.71742 -3.27048 6.46822 -3.34517 -375 2 12.885 0.18837 0.429335 -4.8121 3.35952 -2.50919 -376 1 5.70486 15.0289 14.4325 -10.0966 26.0987 -8.04315 -377 2 4.75654 15.1126 14.6498 8.83064 -2.51751 -1.0487 -378 2 5.99172 15.9344 14.1552 -2.67099 -19.6319 8.34541 -379 1 3.68772 6.51886 1.67786 -9.02664 17.532 -4.1283 -380 2 3.3123 7.35563 1.32777 6.95322 -18.4916 -0.718273 -381 2 3.69933 6.70385 2.62114 4.49099 -5.2411 1.79351 -382 1 3.84119 11.2683 12.301 -11.0219 1.87445 3.30422 -383 2 4.7083 11.6207 12.5295 0.62865 1.71432 1.43021 -384 2 3.16952 11.829 12.7259 9.18863 0.324364 -2.3982 -385 1 5.33774 3.90131 15.6575 3.88008 58.1131 -0.302695 -386 2 6.0029 3.30263 15.356 18.6017 -19.7261 -0.90724 -387 2 5.77609 4.81808 15.6348 -20.8077 -39.2998 1.51453 -388 1 13.9476 10.0954 4.76119 43.1598 -13.631 -14.8551 -389 2 14.3099 9.89525 5.64952 -11.5358 -2.78357 -16.2598 -390 2 14.5437 9.62633 4.09138 -26.3956 16.5702 30.5617 -391 1 7.47949 17.2779 8.9575 1.27559 12.2273 10.3752 -392 2 6.80648 17.541 9.63427 13.3482 -0.885269 -20.4433 -393 2 7.81637 18.0666 8.4826 -8.0179 -7.75644 7.92076 -394 1 4.60365 14.3557 3.73459 -2.67085 -0.0597314 40.4087 -395 2 4.53549 15.2621 4.14744 4.43815 -28.6634 -11.7113 -396 2 4.62044 13.6529 4.46513 -1.80956 31.3212 -27.6241 -397 1 14.2431 7.29194 15.9057 25.6353 16.9765 2.1683 -398 2 15.0475 7.32515 15.3368 -17.0197 -3.00413 14.2387 -399 2 14.4656 7.87429 16.6673 -6.53416 -15.6271 -13.0076 -400 1 2.96496 18.4208 1.99119 15.7852 32.1682 20.7835 -401 2 2.67672 17.8955 1.28044 -15.5564 -27.5435 -28.9446 -402 2 2.23493 0.385121 2.17733 5.2916 -3.96739 2.45348 -403 1 7.98476 1.5873 4.50407 1.38949 2.52923 0.695279 -404 2 7.37343 2.0449 3.91068 5.19751 -1.80104 2.00097 -405 2 8.86519 1.9238 4.29038 -5.22298 -3.29695 -0.501883 -406 1 2.57117 14.1691 17.7571 1.007 -17.2424 4.53378 -407 2 1.90219 13.4698 17.9606 14.5878 19.4169 -2.4542 -408 2 3.44824 13.7555 17.8862 -10.6426 1.83574 2.42644 -409 1 1.00451 2.03285 13.8784 10.3502 2.39599 -10.3714 -410 2 1.16144 1.84563 14.7992 2.97823 -2.88805 14.0985 -411 2 0.0700994 1.90667 13.7535 -13.5508 1.82952 -2.05389 -412 1 4.33902 0.200757 13.8843 13.0721 -10.005 -1.30306 -413 2 5.22858 18.4296 13.858 -15.0619 9.43809 1.75921 -414 2 3.93054 18.5168 14.6942 4.28146 4.19272 1.73225 -415 1 7.39543 1.05973 18.4904 -6.66444 -3.84456 4.72925 -416 2 7.66739 0.634389 17.6825 2.48525 -3.87431 -15.5197 -417 2 6.44311 1.20989 18.4324 3.08246 -0.882049 5.31666 -418 1 15.7652 18.4035 13.928 -3.86344 6.1861 11.5309 -419 2 14.8535 18.6979 13.7607 9.26883 -6.83338 6.65234 -420 2 15.8985 -0.310566 14.8997 -7.7909 7.80446 -17.2978 -421 1 10.2952 4.64795 16.1844 -42.7729 -17.7833 -2.18791 -422 2 11.2045 4.84382 16.2798 37.5776 1.06228 1.58962 -423 2 10.2217 3.67206 16.1998 1.46017 15.0252 -2.22652 -424 1 15.8927 17.6472 4.46477 -15.4234 23.5431 17.5975 -425 2 16.4754 18.4255 4.65687 -16.3789 -18.5079 -6.3799 -426 2 14.9773 17.9018 4.78742 33.6258 -6.52099 -13.8394 -427 1 6.90155 17.6195 13.966 46.0362 -18.082 7.69792 -428 2 7.5054 17.5909 14.7751 -24.8486 6.04139 -28.3759 -429 2 7.50943 17.3755 13.214 -16.8133 11.713 21.5591 -430 1 13.2082 6.37265 6.52765 -13.548 -6.29238 7.5029 -431 2 14.0171 6.83631 6.34759 17.8515 4.0742 0.884882 -432 2 12.7912 6.26458 5.66961 -1.80962 -1.49443 -3.94736 -433 1 7.85263 2.26509 9.52735 -7.99894 -5.84405 -22.7054 -434 2 7.25184 2.06178 10.2504 -3.996 2.15095 3.09306 -435 2 7.39499 1.97805 8.69805 10.2818 7.88442 20.3126 -436 1 15.1135 14.8377 13.7906 -14.0873 7.85215 4.54273 -437 2 14.8065 15.1503 14.6696 4.89633 -5.66092 -15.9193 -438 2 14.526 15.2486 13.1323 8.68819 -2.70507 8.56313 -439 1 9.34389 8.42481 3.82801 17.2784 -12.6228 -3.36469 -440 2 10.2481 8.71643 4.0808 -19.781 -0.493733 -4.13474 -441 2 9.39514 7.45876 3.71283 -1.01674 10.6173 4.41109 -442 1 17.6406 13.5721 16.5094 2.04355 14.6677 -13.2606 -443 2 16.6957 13.3564 16.5004 3.03121 5.86868 -4.35941 -444 2 17.7908 14.3862 15.9732 -9.46726 -16.3028 8.56732 -445 1 4.98477 10.3524 2.78056 12.7386 5.36526 19.5004 -446 2 5.77841 9.87677 3.08402 -8.11584 2.70387 -5.95057 -447 2 4.78102 10.9105 3.55814 -3.18863 -4.34789 -14.1468 -448 1 3.61985 8.409 9.90418 -6.90754 6.83907 7.996 -449 2 3.65115 9.35813 9.71914 3.08439 -3.40065 -3.71786 -450 2 3.2182 8.36489 10.7858 3.70965 -2.47637 -5.74153 -451 1 15.9601 6.9243 5.80742 5.84252 7.06727 3.15212 -452 2 16.6786 7.33659 6.3256 -10.6597 -9.43019 -8.8571 -453 2 16.2068 5.99858 5.66915 1.21675 5.97088 2.68601 -454 1 15.2845 7.30815 8.96614 12.789 49.367 -12.5087 -455 2 15.9618 7.62249 9.60336 -10.429 -10.3168 -7.48119 -456 2 15.189 8.09577 8.33246 -3.07462 -40.144 23.8491 -457 1 6.1828 12.7537 12.7561 7.28509 13.2747 4.63662 -458 2 7.05451 12.4627 13.0861 -13.4204 -0.208789 -0.140696 -459 2 5.95622 13.5898 13.2147 8.13015 -13.1574 -2.88232 -460 1 12.1263 4.55994 13.1396 29.7192 24.8274 2.05513 -461 2 12.1786 4.68706 14.0984 -0.0287765 -3.56256 -2.83377 -462 2 11.367 4.05454 12.9285 -29.3831 -17.3036 -0.987503 -463 1 11.4694 8.07241 7.80966 2.82892 -5.30182 3.11258 -464 2 12.1089 7.42736 7.43222 -7.16455 14.3649 9.80055 -465 2 11.7078 8.26067 8.74179 3.19872 -8.99269 -16.594 -466 1 16.9463 10.7531 7.60486 21.0922 -19.3927 -30.7185 -467 2 17.5464 10.0071 7.31859 -16.0594 21.8542 15.0855 -468 2 16.9098 11.3402 6.82058 -3.06841 -4.58473 14.7168 -469 1 5.28146 18.0409 10.6472 -25.9515 -7.83546 -6.26387 -470 2 4.85268 17.2439 11.0337 11.609 18.382 -10.1496 -471 2 4.62194 18.3715 9.98111 20.3861 -11.8767 18.8687 -472 1 7.65293 17.466 1.56177 -3.43219 -2.17163 16.4468 -473 2 8.27069 16.8213 1.23778 3.23069 -17.6415 -5.16563 -474 2 7.58305 18.0963 0.859771 -3.72786 20.9018 -9.77855 -475 1 1.92587 12.9087 13.6164 -8.16731 5.11551 18.4441 -476 2 1.30634 12.3949 14.1755 13.4846 7.44573 -7.00244 -477 2 2.13079 13.7319 14.1159 -1.95883 -16.9131 -9.84331 -478 1 9.29336 6.75339 14.7687 -19.1125 21.7104 1.76678 -479 2 9.711 5.9819 15.1082 15.9481 -24.452 8.13362 -480 2 9.58853 6.88119 13.8676 2.75751 0.822828 -8.36077 -481 1 15.2452 4.28737 10.7623 -0.225576 -4.08648 -1.74219 -482 2 16.1503 3.99339 10.8719 6.1947 -5.72264 -8.71474 -483 2 15.1717 4.92602 11.4736 -7.0877 3.5816 0.665059 -484 1 11.4391 6.24473 0.0517087 -15.4849 -28.4826 -7.88372 -485 2 11.5335 5.29025 18.4586 5.11122 21.8085 5.83846 -486 2 10.469 6.36117 18.7264 13.3105 4.99187 -1.92993 -487 1 18.4571 11.4845 14.9094 -8.14212 27.2991 -26.8701 -488 2 18.0442 12.0056 14.1458 10.7134 -26.1217 30.6713 -489 2 18.3691 12.0954 15.6567 -1.55188 -2.54901 -1.51407 -490 1 7.07006 9.2713 7.35429 3.52198 -23.4346 -4.90088 -491 2 6.57918 8.46088 7.59869 6.01934 15.522 -0.341791 -492 2 7.98054 8.95273 7.2441 -4.91945 6.78887 2.19469 -493 1 18.4213 15.3485 12.1512 14.6289 14.7183 -5.00343 -494 2 0.703338 15.6554 12.0361 -12.928 -5.55139 4.18882 -495 2 17.8805 15.9633 11.6295 -1.60931 -6.92771 2.64168 -496 1 16.5853 4.3259 5.32941 -3.23822 -14.2219 46.7572 -497 2 16.614 4.15863 6.32722 1.43031 7.89007 -40.0485 -498 2 17.5031 4.43236 5.0545 -4.12857 4.88068 -4.00684 -499 1 17.7656 3.15988 10.7489 -7.77815 -3.54726 5.22618 -500 2 18.6517 3.33727 11.1036 -6.02481 -6.41431 -8.69585 -501 2 17.7347 2.25304 10.4054 5.10772 5.83768 0.491016 -502 1 12.3532 18.6195 10.0845 2.26138 29.9542 0.82462 -503 2 11.4554 0.369133 10.2956 34.814 -7.7062 -6.49387 -504 2 13.0539 0.703372 10.1287 -31.4455 -25.8056 2.12568 -505 1 10.4062 9.7592 12.5463 4.94309 9.48659 9.1975 -506 2 11.1178 9.86775 13.2051 -4.84217 -3.21907 -8.75193 -507 2 10.4169 8.83 12.3092 -0.242296 -5.43122 1.67162 -508 1 0.754807 2.57366 7.2759 5.10959 9.37805 -1.17349 -509 2 1.15147 3.40426 7.59563 -2.53061 -11.14 3.70439 -510 2 0.94825 1.90755 7.95351 -0.370046 8.4477 -4.76995 -511 1 0.326852 15.3245 6.92393 7.78779 -47.7914 -15.9381 -512 2 0.478367 15.1955 7.87742 -3.54148 6.5065 -12.4551 -513 2 0.511792 14.4078 6.50445 -6.22026 47.2618 21.2659 -514 1 17.0448 6.87527 14.9011 7.50868 -3.64469 2.18783 -515 2 17.7829 7.50382 14.839 -4.82102 -5.02166 1.59119 -516 2 17.384 6.09018 15.3732 -3.19441 8.7454 -5.86774 -517 1 9.10521 12.4991 8.01627 -22.444 -7.37457 -9.07321 -518 2 9.5155 11.7197 7.59468 -6.97176 5.64777 -5.01838 -519 2 8.17012 12.5725 7.67989 31.3303 -7.17656 9.91942 -520 1 1.12679 1.65794 2.79756 -4.95635 8.46302 6.6874 -521 2 0.642552 2.15227 2.11219 8.6081 -1.07022 6.53976 -522 2 1.60228 2.28223 3.37541 -5.16033 -3.32404 -9.46208 -523 1 4.24509 15.0269 10.0531 -9.28044 4.63084 -2.70058 -524 2 3.93721 15.2031 9.15401 2.26907 2.00751 2.33164 -525 2 5.07496 14.5648 9.92961 6.13338 0.348707 3.17177 -526 1 7.39613 2.22212 14.8791 -10.1428 -2.73186 -2.62368 -527 2 7.12857 1.59843 14.1951 -0.211704 -1.85534 3.14611 -528 2 7.6308 3.01777 14.3992 6.19568 3.75469 -5.36272 -529 1 18.3005 14.5161 2.14907 5.30067 -9.26209 1.4902 -530 2 0.506128 14.8057 2.49377 4.6744 -0.083839 -4.04908 -531 2 17.8019 15.308 1.97101 -9.85855 11.1774 -0.48774 -532 1 10.0782 2.71092 12.8944 3.88974 -3.73664 -2.78909 -533 2 9.88925 2.05355 12.2072 4.3936 3.86452 2.74403 -534 2 9.31937 3.3006 12.9074 -3.94823 0.261307 -1.05017 -535 1 2.9306 8.79131 12.9512 -25.6961 -20.8645 -0.44372 -536 2 3.33593 9.62792 12.788 10.417 21.0465 -4.83397 -537 2 3.64632 8.1716 13.058 11.1871 -7.80414 6.67576 -538 1 3.17851 8.59155 3.78391 36.0219 9.48042 20.5594 -539 2 3.64638 9.17092 3.16182 -4.0064 -4.18597 2.27442 -540 2 3.67104 8.74964 4.63715 -24.9674 -6.25544 -24.3579 -541 1 5.79667 7.27872 8.61723 -5.158 -8.45889 2.36629 -542 2 5.76122 6.32524 8.453 -1.10357 3.40671 2.32671 -543 2 5.00318 7.4879 9.12925 4.38374 0.567505 0.838777 -544 1 14.9116 1.65307 1.84567 7.03031 -5.18946 -10.6018 -545 2 15.1062 2.45757 2.3139 -4.94852 6.93451 15.0643 -546 2 15.1691 1.84916 0.935056 -0.310542 -6.30296 3.0909 -547 1 8.67523 15.0369 0.613894 1.37845 1.1536 3.61737 -548 2 9.43682 15.0729 1.21213 -3.42809 -6.51916 3.89646 -549 2 8.00447 14.4711 1.03609 4.49017 7.63347 -1.72767 -550 1 15.3993 1.47022 7.19229 -20.8703 -2.58026 0.276614 -551 2 14.6837 0.967989 6.72584 19.4319 15.0033 11.4079 -552 2 14.9834 2.26826 7.5843 2.60239 -12.333 -11.18 -553 1 4.89704 12.855 18.4725 17.7474 3.66438 12.0852 -554 2 5.22521 13.0209 0.739851 -5.30909 -3.44768 -15.7686 -555 2 5.64886 13.1114 17.9131 -8.88833 1.88365 4.35483 -556 1 15.3966 8.71526 18.0579 -0.0737912 10.217 -6.92241 -557 2 15.7913 9.20885 17.3059 -4.72516 -6.1114 19.2356 -558 2 15.2466 9.35419 0.13361 -0.210218 -4.05252 -7.18588 -559 1 11.9654 3.16879 18.3684 -1.96391 -6.33771 9.57431 -560 2 11.8782 2.93896 0.667559 5.83177 -2.01678 -11.7343 -561 2 12.3624 2.38725 17.9444 -0.743858 8.0566 3.61175 -562 1 13.1976 12.733 5.19814 3.21154 2.81721 -3.88454 -563 2 13.6265 11.8743 5.11099 -2.80289 -1.59076 -2.45209 -564 2 13.3962 13.0406 6.08845 -1.48061 -3.43823 1.63358 -565 1 6.20234 7.07161 0.291392 8.37087 -8.50913 -15.2358 -566 2 6.21431 8.03007 18.9132 -3.08565 9.14852 3.50692 -567 2 5.28911 6.79756 0.384068 -8.05152 4.04277 7.5169 -568 1 17.755 15.8811 14.8809 -0.846783 4.67036 -1.95176 -569 2 16.8205 16.1356 14.922 6.46156 -5.25763 -8.70949 -570 2 17.9775 15.7319 13.9423 -7.01069 1.37948 9.8425 -571 1 13.0816 0.927432 16.7559 7.19813 -13.1533 1.9849 -572 2 14.0246 0.654652 16.7787 -14.5584 8.9122 1.46691 -573 2 12.5958 0.0867106 16.6751 4.09548 8.26383 -2.86333 -574 1 10.8721 14.5032 7.42074 17.8947 27.9436 -17.0444 -575 2 10.196 13.9242 7.71676 -22.829 -18.2345 11.9548 -576 2 11.6972 14.0514 7.58445 7.42519 -9.80791 -0.577526 -577 1 17.7647 8.42346 2.16939 -4.1598 1.60766 -5.89387 -578 2 16.8709 8.3975 2.49669 -12.234 5.23478 11.868 -579 2 17.7295 7.75318 1.48744 5.54579 -3.65645 -10.0136 -580 1 12.5773 7.79072 2.0332 1.0668 2.49746 -6.2566 -581 2 12.3914 8.73063 1.87761 -0.101344 -7.79782 -0.82295 -582 2 12.2276 7.2965 1.27263 1.31444 5.98607 5.5368 -583 1 12.0208 14.4615 10.4933 -27.7219 6.00234 -17.9899 -584 2 12.3406 14.2687 9.58404 -10.0812 4.98999 20.4987 -585 2 11.0483 14.7039 10.4238 33.6221 -8.97773 -1.58279 -586 1 6.69486 6.68845 15.5484 18.1135 9.98152 11.3143 -587 2 7.65688 6.85274 15.3559 -27.8703 -4.06425 5.81014 -588 2 6.48582 7.17335 16.3722 6.10572 -10.2019 -13.6564 -589 1 7.96659 4.39718 13.2272 4.51058 -7.9075 4.77481 -590 2 7.2893 4.70584 12.6248 -6.54048 3.46732 -4.14994 -591 2 8.21018 5.15068 13.7582 2.30488 10.1178 3.17748 -592 1 13.2671 12.2369 14.4347 -4.64765 -4.51239 1.04229 -593 2 13.0608 11.2949 14.304 4.07546 7.63325 0.952283 -594 2 13.624 12.5445 13.5893 -0.484314 -1.81518 4.66288 -595 1 14.4631 9.64208 7.37348 -3.22195 -17.9745 -8.46037 -596 2 15.2455 10.1455 7.54143 19.6931 12.3162 5.07411 -597 2 13.7594 10.075 7.84063 -11.2512 5.66435 9.63044 -598 1 12.6955 16.8004 3.38503 4.61351 40.5798 -15.2407 -599 2 12.79 17.4151 4.16128 -2.51333 -18.5745 -25.4999 -600 2 12.6728 17.373 2.55111 0.0132769 -17.6878 38.2975 -601 1 0.968812 6.96727 17.3326 -17.527 29.8281 -14.7856 -602 2 0.0966102 7.11435 17.7475 9.38145 -12.9539 -1.45746 -603 2 0.942675 7.56475 16.5473 6.51552 -11.7527 16.88 -604 1 12.9918 4.86088 15.7598 14.9884 1.53364 0.213735 -605 2 13.6417 4.12341 15.6561 -13.2544 27.5281 4.62454 -606 2 13.5036 5.69571 15.8607 -8.5455 -17.4296 -3.38108 -607 1 2.31456 3.41181 5.02375 -16.8072 14.5355 28.5245 -608 2 1.72499 3.01856 5.74541 26.0591 16.5367 -23.5498 -609 2 2.61813 4.33638 5.31016 -13.7452 -42.3935 -5.38282 -610 1 8.12877 10.8743 13.7813 26.8177 -26.1009 35.9685 -611 2 8.08888 10.4248 14.7095 5.12746 27.8083 -58.2879 -612 2 8.93477 10.511 13.3312 -19.2021 7.65314 13.0743 -613 1 13.0038 1.57226 13.2324 0.46489 2.31008 -10.6366 -614 2 13.6096 1.43937 12.4592 -18.9356 10.6634 16.2552 -615 2 12.412 2.34128 13.062 19.3329 -16.3736 -0.813643 -616 1 6.65189 13.7072 1.97939 -2.77776 -1.20266 13.9341 -617 2 6.01392 14.2112 2.53362 13.0928 -13.1372 -7.18637 -618 2 7.15166 13.1216 2.589 -8.8324 11.1791 -7.86511 -619 1 15.7768 6.33135 12.4394 -16.9523 -8.61752 -2.39927 -620 2 16.2545 6.83373 11.7966 11.5481 11.8457 -13.8092 -621 2 16.2346 6.49819 13.2509 8.584 1.06891 20.063 -622 1 16.7487 0.656157 9.53186 -1.89022 -32.3669 -10.6998 -623 2 16.6929 18.3191 9.69193 -1.14735 24.5709 0.588436 -624 2 16.3744 0.798362 8.64008 0.39513 1.76057 8.35052 -625 1 6.2256 11.6996 8.23382 -7.45249 -33.5883 4.29961 -626 2 5.41287 11.5766 8.79278 22.02 -5.73867 -21.2662 -627 2 6.53136 10.7979 7.88958 -15.1732 37.063 20.6987 -628 1 2.75779 8.608 0.340468 -48.3199 -4.33351 -7.97969 -629 2 2.08546 8.0585 18.4464 30.1073 27.602 24.3697 -630 2 2.23564 9.25518 0.892435 12.8354 -18.7139 -20.5564 -631 1 10.0773 10.2182 6.62419 2.67327 1.92209 4.62159 -632 2 10.5668 9.53044 7.10449 -1.07652 4.95909 -5.68289 -633 2 10.5655 10.3766 5.79827 -6.62323 -4.53969 7.46345 -634 1 6.84859 15.7294 6.8116 4.5172 -4.61086 -5.81045 -635 2 7.14728 16.2498 7.57791 -4.63192 -2.64256 -11.095 -636 2 7.17659 16.1616 6.00258 -4.95191 3.23702 9.76552 -637 1 6.62071 12.9207 5.93401 2.33655 2.8557 1.84805 -638 2 6.83452 13.8255 6.17261 -0.629609 6.79635 0.913528 -639 2 6.25462 12.5309 6.73716 -1.14115 0.401949 -5.14594 -640 1 16.7089 12.5339 9.77339 -0.869689 -1.39856 -8.71911 -641 2 16.7622 11.7819 9.15626 3.31473 10.0385 4.47785 -642 2 17.1611 13.2788 9.34464 -3.7572 -10.2702 6.17681 -643 1 6.29845 2.79213 2.75928 -3.20566 -14.4941 8.67087 -644 2 6.41489 3.68807 2.47435 5.42045 18.7619 -3.24562 -645 2 5.94058 2.32523 2.00482 -4.41542 -3.11109 -6.82659 -646 1 10.6289 2.95834 3.25769 -6.57134 8.8614 -3.08687 -647 2 10.3824 3.87829 3.42309 -0.834706 -5.50201 2.33367 -648 2 10.1446 2.71475 2.45701 2.51779 -3.35726 0.152255 diff --git a/examples/amoeba/dump.water_box.hippo.32 b/examples/amoeba/dump.water_box.hippo.32 deleted file mode 100644 index 33463a3a5d..0000000000 --- a/examples/amoeba/dump.water_box.hippo.32 +++ /dev/null @@ -1,7227 +0,0 @@ -ITEM: TIMESTEP -0 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.67966 7.08769 17.9461 -19.3527 -13.639 6.25201 -2 2 7.80945 6.75579 18.2607 18.4949 11.1596 -6.01922 -3 2 8.72223 6.81424 17.0254 5.85599 -0.890166 3.45586 -4 1 18.5257 8.24445 6.83762 11.8085 12.5587 58.8481 -5 2 0.216892 7.89544 6.05003 10.8935 -14.9684 -50.5046 -6 2 0.444268 7.82601 7.5302 -15.2958 7.9793 -8.89884 -7 1 8.37906 18.5504 6.81463 25.5385 6.64228 -3.75624 -8 2 9.34042 0.098069 6.73406 -20.9151 -2.68951 1.38711 -9 2 7.93962 0.573676 6.26984 -0.656308 -0.308718 3.40946 -10 1 6.58995 1.84432 11.7198 46.6828 -15.9611 -12.5859 -11 2 5.88543 2.40231 11.9251 -37.6261 28.8114 18.1934 -12 2 6.18153 1.06275 11.3693 -6.58868 -16.6156 -5.55691 -13 1 7.1466 5.75358 2.33152 -56.1364 42.5085 -2.61462 -14 2 6.36812 6.12603 2.86268 40.1937 -23.4301 -4.21826 -15 2 7.02502 6.29465 1.5182 16.3021 -20.7884 10.9258 -16 1 16.2164 10.1388 16.1382 -32.0875 21.5958 16.7579 -17 2 16.9509 10.2747 15.5847 32.9015 -1.03241 -20.1636 -18 2 15.8498 11.0405 16.2399 1.98783 -14.756 2.71439 -19 1 10.6046 15.0374 2.30369 -8.13409 -25.494 -7.18668 -20 2 10.5292 14.3949 3.01849 1.41683 -0.603724 2.75561 -21 2 11.0236 15.78 2.70962 11.6057 19.8833 4.5888 -22 1 17.1624 8.24409 10.3708 13.0676 7.07862 9.73504 -23 2 16.5528 8.68798 10.966 -4.65968 7.37974 1.83434 -24 2 17.9421 8.82333 10.3208 -6.34155 -10.1937 -2.20396 -25 1 14.901 15.8652 16.3167 18.01 -6.87509 18.5636 -26 2 14.0225 16.1982 16.2525 -26.9236 12.7201 -6.50875 -27 2 14.9141 15.482 17.2099 2.63751 -6.05913 -7.59706 -28 1 12.1752 13.3771 0.408263 -11.3168 6.26442 9.98381 -29 2 12.0579 13.8465 18.23 5.67057 -4.50268 -16.0578 -30 2 11.6217 13.8904 1.00796 3.42507 -1.00312 9.73088 -31 1 9.27358 5.34243 4.05546 -35.2781 32.5984 16.8393 -32 2 8.64594 5.4665 4.83764 28.3783 -16.8163 -28.778 -33 2 8.74177 5.68615 3.30282 7.52493 -14.9247 9.48156 -34 1 1.83016 4.27673 11.6495 -21.1764 37.5598 -8.14901 -35 2 1.70328 5.22377 11.9391 6.02814 -28.7768 -8.29565 -36 2 2.40811 3.85345 12.2597 13.4728 -11.3181 18.3421 -37 1 1.96438 6.83299 8.3731 -11.1902 3.43717 -25.3738 -38 2 2.49614 7.21578 9.0563 9.35281 -0.190165 18.6039 -39 2 1.81128 5.90585 8.57354 7.84101 -3.79534 5.21373 -40 1 5.40557 4.38899 7.93274 -6.81526 4.7224 -2.63907 -41 2 5.53738 3.43895 7.78131 -7.79962 9.88898 0.533881 -42 2 4.75516 4.73491 7.29062 10.7858 -16.238 7.24535 -43 1 3.23 2.92842 17.5524 -0.538114 20.9936 16.7312 -44 2 3.93109 3.19827 16.9402 -0.965509 8.21721 4.01649 -45 2 3.00444 3.70897 18.1497 6.13449 -29.114 -23.6081 -46 1 7.4624 5.26283 6.13117 9.12728 4.25284 -1.73168 -47 2 8.02565 5.58849 6.88177 -24.817 -14.4341 -14.6054 -48 2 6.93508 4.45577 6.3254 16.0496 22.0303 12.0173 -49 1 9.77896 7.02384 11.9834 11.1205 -3.87253 23.9446 -50 2 10.2721 6.37256 11.5011 10.9222 -10.0302 -1.39678 -51 2 9.1532 7.31587 11.3499 -23.6433 13.1239 -20.7784 -52 1 14.1167 3.54999 8.03003 -30.7601 -1.60704 -37.9113 -53 2 13.4732 4.22413 7.73132 15.1608 -10.723 4.30178 -54 2 14.3809 3.80189 8.88487 12.8065 16.1495 34.678 -55 1 4.82329 17.2568 4.03846 -17.85 32.0436 -31.4073 -56 2 5.49315 17.973 4.01308 -7.71314 -24.6342 10.4391 -57 2 4.18746 17.5412 3.33843 10.9703 -13.5421 12.8553 -58 1 16.4918 16.6259 10.0493 29.9016 15.3745 -40.7533 -59 2 16.1673 16.3226 10.8594 -24.6786 -13.0437 37.8908 -60 2 15.9925 16.2084 9.33562 -4.01544 -1.82242 7.63759 -61 1 1.94489 4.93323 0.49791 29.1886 10.4759 3.59715 -62 2 2.55322 5.26335 1.2053 -17.2324 -10.4098 -15.9422 -63 2 2.08253 5.591 18.4408 -14.7087 -3.80383 3.81857 -64 1 11.816 13.3571 16.2711 -7.8083 1.12937 6.2001 -65 2 11.2371 12.6203 16.5671 13.3708 1.96491 -16.2063 -66 2 12.2446 13.1893 15.4079 -11.197 -7.32732 11.8633 -67 1 10.105 11.0651 16.9545 16.7158 -32.7784 1.37979 -68 2 10.5674 10.1947 17.1295 -14.0823 30.097 -5.45833 -69 2 9.25349 10.8067 16.5912 -2.99511 2.11526 2.57572 -70 1 11.7264 17.5421 13.4742 2.50122 -25.0158 -11.214 -71 2 12.2771 16.9836 12.8968 -8.91486 0.79877 6.23222 -72 2 12.1041 18.3936 13.317 1.59091 22.4782 2.42571 -73 1 6.33029 9.31911 12.2264 15.6898 -25.4439 -25.1534 -74 2 7.02603 8.96242 11.6353 -17.823 2.07037 1.33758 -75 2 6.81249 9.95941 12.7172 5.93051 22.1649 19.4162 -76 1 16.2187 12.7249 2.70186 -8.69715 -37.3569 7.82337 -77 2 17.0292 13.1566 2.50302 19.6243 18.7999 -9.68795 -78 2 15.4982 13.3357 2.61812 -8.61102 21.6356 1.57727 -79 1 0.637202 12.5625 5.84914 -32.6687 7.10288 -2.13707 -80 2 0.892312 12.5507 4.90771 -4.51242 -1.40786 13.4578 -81 2 18.3039 12.804 5.85329 37.5994 -4.88925 -6.97833 -82 1 5.19922 16.3781 18.5047 -7.71264 -0.634541 -12.9921 -83 2 5.80284 15.8543 17.9455 2.11468 10.7978 13.7187 -84 2 5.67034 16.9636 0.462296 7.23142 -5.58048 -3.24093 -85 1 0.510145 7.62945 4.0545 45.851 19.5686 -25.4796 -86 2 18.5719 8.14656 3.45296 9.61971 -16.7838 10.3831 -87 2 1.46496 7.74082 3.66917 -52.3954 -1.94356 25.3273 -88 1 3.14672 8.89584 6.52626 -54.2957 5.34018 -1.73828 -89 2 3.50609 8.59991 7.35294 9.18701 -2.26398 8.55435 -90 2 2.14573 8.92962 6.68203 45.3688 -0.563656 -9.64228 -91 1 7.30854 10.3037 16.1717 -0.0267506 0.140778 15.7468 -92 2 6.56213 10.4624 15.5802 1.32412 -0.384411 10.7132 -93 2 6.99303 10.278 17.1118 0.130505 3.94788 -23.0495 -94 1 11.1122 1.06968 4.98939 -2.83136 -16.8604 13.0177 -95 2 11.0776 1.97142 4.64864 2.2702 -4.31387 -11.6367 -96 2 10.7048 0.433547 4.37027 2.96408 14.9419 -2.56144 -97 1 4.45204 2.70061 13.2052 -8.32298 -31.9478 35.5434 -98 2 4.60333 3.05865 14.0914 -0.476624 15.5497 -15.2927 -99 2 4.38645 1.737 13.4626 0.207127 24.1129 -25.2696 -100 1 8.42792 10.0237 1.78469 -10.6267 -17.9408 16.848 -101 2 8.3405 10.6377 2.53622 4.43246 -2.98222 -4.40025 -102 2 8.49672 9.11244 2.17467 4.60711 29.3182 -9.45134 -103 1 10.5335 1.75383 15.546 -31.9958 -1.22726 0.532554 -104 2 11.3977 1.82718 15.9216 23.4057 -5.242 -0.0927752 -105 2 10.5608 1.78317 14.5837 3.34522 3.38855 0.282019 -106 1 2.77693 12.941 7.74821 -10.6415 2.34425 -2.27994 -107 2 3.28797 13.5733 7.23382 5.58977 0.334345 4.09149 -108 2 1.98704 12.8256 7.20013 5.22386 -8.52712 2.54059 -109 1 3.63517 11.6895 5.33963 -10.2259 -13.0028 -10.3717 -110 2 3.35385 11.0502 6.03137 4.73753 15.317 -16.6328 -111 2 2.8758 11.855 4.74058 11.3048 -4.09559 12.5928 -112 1 6.88803 14.474 16.8428 -13.42 9.46677 6.94107 -113 2 7.55973 13.8293 16.6383 4.5229 -1.76969 -1.40507 -114 2 6.60381 14.8838 16.0165 0.0834179 -9.06129 -0.120708 -115 1 14.1722 14.5374 3.41536 20.1951 -3.19134 -21.8839 -116 2 13.6514 15.2845 3.14096 -9.23852 13.3738 0.77613 -117 2 13.8512 14.2508 4.25439 -13.5451 -9.47926 16.7085 -118 1 8.28226 18.1809 16.0824 -9.43856 -15.6135 -5.07226 -119 2 8.77677 17.3494 16.3071 1.43839 31.5077 -5.33478 -120 2 8.7603 0.384816 15.9919 11.1327 -19.5096 4.24776 -121 1 4.73724 1.61643 4.90111 5.86874 37.6921 -30.6753 -122 2 3.96969 2.16837 5.15263 9.12039 -10.9712 -6.28456 -123 2 5.18465 2.1484 4.15475 -17.6049 -26.8232 41.7187 -124 1 15.1457 12.8616 16.4403 -17.0638 -11.2899 43.408 -125 2 14.6041 12.8692 17.2613 22.7365 8.03356 -12.6578 -126 2 14.49 12.6307 15.8136 -17.0236 -4.89604 -35.7974 -127 1 15.779 18.3837 16.786 48.5063 8.0766 44.3104 -128 2 16.5108 18.615 17.4688 -41.9285 -7.99937 -34.0327 -129 2 15.7694 17.4186 16.7687 -10.3466 2.2793 -1.1406 -130 1 1.1383 1.1331 16.5571 -3.54071 10.9478 5.94974 -131 2 1.96551 1.50352 16.9177 -15.9767 0.55296 -3.51275 -132 2 0.420521 1.53444 17.0916 21.5279 -7.8795 -5.43288 -133 1 18.0817 4.5907 15.863 15.8138 -19.1991 -2.64562 -134 2 18.5818 3.91936 15.3489 -11.6552 16.5822 9.8521 -135 2 18.5602 4.7339 16.6874 -1.16116 -1.56098 -3.02727 -136 1 12.22 16.9378 16.1148 -9.97587 -12.4224 57.0196 -137 2 11.409 16.6934 16.6676 29.0172 6.05041 -31.7989 -138 2 11.9646 17.3216 15.2917 -14.4882 2.9648 -22.1743 -139 1 15.8709 2.55221 17.9707 -3.56258 26.452 -16.7944 -140 2 15.7355 3.48355 18.2574 6.35046 -25.5765 3.86241 -141 2 15.6659 2.59235 17.0072 6.0189 -6.56803 19.8103 -142 1 6.70868 13.791 10.2637 1.94011 22.9489 3.02058 -143 2 6.59347 13.548 11.1958 0.710608 -4.45224 -7.92394 -144 2 6.58252 13.0514 9.6765 -3.73143 -16.591 0.344408 -145 1 10.146 18.2027 2.80372 16.894 35.9 -12.6825 -146 2 10.2207 0.331961 2.18345 -1.03174 -23.6422 14.9845 -147 2 9.26571 17.8868 2.67703 -18.7462 -7.34721 -7.1199 -148 1 2.97538 17.748 6.06078 -27.2244 1.77787 1.96995 -149 2 2.09399 17.6473 5.67013 1.23544 -3.46851 16.5241 -150 2 3.45883 17.8838 5.26396 32.1509 0.10025 -8.47089 -151 1 12.558 17.0134 7.97028 2.72879 -14.1128 -3.91884 -152 2 11.9572 16.2512 7.82085 4.20569 13.3061 15.6125 -153 2 12.4657 17.4524 8.83591 -10.4039 -6.95813 -9.08653 -154 1 14.8795 15.2862 8.28544 5.56082 -19.5077 38.9848 -155 2 13.9824 15.6136 8.40666 -1.04882 8.68143 -14.5015 -156 2 15.2312 15.4641 7.43118 2.2507 10.8701 -29.8329 -157 1 17.5429 18.3228 0.375372 -51.3852 -2.4253 -14.1847 -158 2 18.116 17.6308 0.128652 38.5367 -21.5025 -8.63787 -159 2 17.9698 0.288559 0.934677 24.3068 21.4661 19.9837 -160 1 0.910209 10.3712 1.41143 -2.71779 -52.992 43.3073 -161 2 0.158544 9.88347 1.87089 22.0109 19.7614 -26.7074 -162 2 0.565924 11.0969 0.944383 -22.7833 34.6337 -23.5778 -163 1 1.55407 12.175 3.31087 16.6578 22.9783 50.8488 -164 2 1.36245 11.4802 2.72234 -7.70692 -21.3552 -33.2695 -165 2 1.61623 13.0206 2.87285 -0.913798 3.83337 -14.7861 -166 1 0.543127 17.2543 4.88609 29.8094 34.6465 -52.7559 -167 2 0.11032 17.9772 5.31124 -19.8915 12.2203 12.8491 -168 2 0.420366 16.4266 5.2673 -10.0988 -43.8479 36.8786 -169 1 1.10053 1.01949 9.38768 20.7334 -4.84081 3.89797 -170 2 1.46081 0.575286 10.1589 7.03147 5.77442 11.7732 -171 2 0.265613 0.594128 9.34525 -29.6063 -3.3853 -10.3011 -172 1 16.8007 2.32783 13.2877 6.1037 15.2386 -31.0559 -173 2 17.0701 2.57314 12.3549 -10.0746 -10.076 30.4228 -174 2 16.4263 1.43993 13.282 1.60122 -3.62923 0.222317 -175 1 2.45231 15.8283 12.1942 27.8718 -10.8871 18.2649 -176 2 2.8623 15.5513 13.0537 -9.1784 7.03247 -27.4702 -177 2 2.91392 15.3801 11.4615 -3.34054 6.42182 7.24567 -178 1 16.435 15.531 5.9458 21.7194 38.3058 -21.2998 -179 2 17.3808 15.5177 6.20547 -16.0791 -6.59953 3.69269 -180 2 16.4147 16.2211 5.22063 -10.9707 -19.0563 26.084 -181 1 5.84547 5.02056 11.8065 15.5941 -20.7973 -13.2046 -182 2 5.55799 5.91374 11.8891 -11.5246 18.633 11.9833 -183 2 5.09 4.45915 11.9819 -3.94875 -1.81326 3.16792 -184 1 15.2214 4.86555 0.731755 -13.7826 -16.8748 28.0949 -185 2 14.6776 4.45845 1.47821 23.1081 18.7106 -26.9415 -186 2 14.6696 4.95834 18.5986 -11.4435 4.17379 2.92627 -187 1 16.3401 16.2933 2.11217 18.5695 -12.4905 -31.3072 -188 2 16.0666 16.7695 2.87319 -12.4192 21.1701 22.1863 -189 2 16.7601 16.9279 1.50378 -10.9162 -1.12869 10.7347 -190 1 0.305885 4.87877 3.79118 -7.51195 53.5881 20.4451 -191 2 0.299338 5.85541 4.09758 -3.10789 -46.5114 -24.0825 -192 2 1.16991 4.5635 4.03062 6.84312 -11.1831 1.05233 -193 1 2.92501 14.9782 15.0356 -4.41813 7.08234 41.1019 -194 2 3.0159 14.7264 15.9987 0.986861 -4.57119 -32.7424 -195 2 2.35392 15.7535 15.1247 6.41577 5.11218 -9.25191 -196 1 1.1115 14.5727 9.55731 53.3594 20.601 -11.7192 -197 2 2.08491 14.4157 9.46275 -24.0912 20.2308 -9.17401 -198 2 0.897072 13.7408 9.90248 -29.0631 -35.5955 19.1061 -199 1 13.6501 16.6688 11.5433 6.78983 17.7214 -9.74398 -200 2 13.4697 17.4567 10.9694 -2.9322 -22.903 16.7504 -201 2 13.5721 15.8897 10.9842 -10.359 0.342192 0.0202177 -202 1 4.73098 1.47842 0.720986 -5.29759 -7.25447 0.0447572 -203 2 4.27169 1.98826 0.034225 -5.56193 -3.14325 9.7343 -204 2 4.11741 0.788607 1.06182 6.25861 16.2271 -3.37713 -205 1 1.42158 18.4663 11.9139 -14.0127 27.0043 -17.9914 -206 2 1.21766 0.394331 12.6648 1.7087 -1.58128 0.41261 -207 2 1.94844 17.765 12.2423 13.0376 -22.9613 11.2697 -208 1 11.5498 10.1018 4.11619 27.4262 20.5676 -21.0421 -209 2 11.5687 10.5955 3.24216 -3.20948 -18.7647 28.9446 -210 2 12.4899 10.1059 4.45555 -29.515 -1.53007 -14.7279 -211 1 8.38254 12.182 3.76573 -26.3924 1.04105 6.81072 -212 2 9.25863 12.501 4.06076 -19.5654 3.48754 6.33549 -213 2 7.63736 12.4251 4.40785 41.4561 -5.4387 -17.0092 -214 1 14.3228 4.03714 3.29709 11.5996 0.889358 18.0886 -215 2 14.8928 4.14179 4.10547 -12.6664 -0.432988 -23.901 -216 2 13.4701 4.45558 3.48891 5.46089 -2.24129 3.2962 -217 1 5.58188 1.78199 7.50513 -33.666 -46.5708 42.0626 -218 2 5.0172 1.13958 8.12095 34.1345 40.5367 -42.64 -219 2 5.33078 1.59122 6.59529 1.4651 -1.13721 -3.53311 -220 1 17.9086 1.12503 4.88467 5.13037 -2.27617 -10.7476 -221 2 18.4038 1.54032 4.14207 -7.55128 -2.38968 19.1857 -222 2 17.6814 1.78344 5.55455 5.62983 -0.00428508 -6.93418 -223 1 6.83101 9.39303 4.49716 -12.9019 3.06885 -29.4929 -224 2 6.83675 9.57499 5.42715 5.2276 -1.57178 18.8103 -225 2 7.66807 8.99049 4.24996 8.60683 3.06936 7.19189 -226 1 2.71406 14.9654 1.962 -12.6433 -7.2797 -26.4735 -227 2 3.33343 14.7912 2.66354 11.3685 -5.36414 4.18623 -228 2 3.09502 14.6645 1.10257 -3.50464 10.9487 24.1748 -229 1 17.279 12.8803 13.1283 -18.5839 20.1434 9.0108 -230 2 16.4044 13.2339 13.3283 -9.51346 -21.2442 0.20606 -231 2 17.6948 13.7346 13.0834 29.6252 3.29486 -10.2855 -232 1 15.0196 10.5818 1.38314 -38.8036 -34.5801 -31.952 -233 2 15.5102 11.1963 1.85791 33.5109 39.8843 28.1173 -234 2 14.3351 11.0964 0.933298 4.14202 -6.46403 5.49191 -235 1 5.71789 6.95838 4.52856 4.11089 -29.6335 9.96606 -236 2 5.85266 7.87985 4.34179 3.17266 16.1428 1.23553 -237 2 6.44364 6.70841 5.13514 -12.5329 -0.461157 -7.94794 -238 1 8.12142 8.26262 10.159 -0.855146 6.49391 46.4818 -239 2 8.58519 8.93965 9.66877 4.4396 1.59282 -10.2318 -240 2 7.56021 7.74854 9.59836 -7.32825 -5.6782 -22.3885 -241 1 13.5311 18.2901 5.8079 -14.4364 -13.815 12.5854 -242 2 12.703 0.102298 5.56963 8.23181 2.14052 6.61043 -243 2 13.2939 17.6289 6.50758 2.60691 23.7973 -17.1373 -244 1 0.327324 2.56344 0.113251 2.62118 15.3541 1.11187 -245 2 18.009 2.52214 18.5736 10.3638 17.1812 4.70476 -246 2 0.724331 3.48299 0.160564 -23.8753 -26.7718 -0.881277 -247 1 12.6396 10.9599 9.76875 -60.0152 14.8867 -10.4701 -248 2 11.6552 10.7306 9.75031 40.0232 26.8927 -4.84212 -249 2 12.944 10.1383 10.0842 28.9404 -31.8014 10.6031 -250 1 0.789377 12.2851 11.08 12.3121 4.77193 16.7259 -251 2 18.4919 12.3017 11.2021 -18.2956 -1.72231 -7.06107 -252 2 1.09088 12.7637 11.8722 5.11265 -11.1183 -7.6011 -253 1 5.04567 7.2193 13.4912 -20.9717 -2.87687 -14.2941 -254 2 5.59899 7.84649 13.0247 8.94565 11.9067 4.64647 -255 2 5.48047 6.97898 14.3058 11.2978 1.34955 6.76892 -256 1 1.28609 6.99027 11.837 -50.3798 -70.0072 -12.7986 -257 2 0.481329 7.14037 11.2978 16.1889 0.462756 10.6855 -258 2 1.71601 7.79102 11.8803 28.8555 60.7949 7.07409 -259 1 15.4442 9.46712 12.3088 17.5488 35.5581 30.8368 -260 2 15.6103 10.4448 12.4444 -11.4156 -32.7422 -13.7105 -261 2 15.5582 9.10301 13.208 -6.0251 -0.167312 -17.6616 -262 1 16.6404 12.9744 5.44078 -0.477448 -16.7093 5.71929 -263 2 16.2955 13.8866 5.54247 6.71099 -18.3284 -17.4666 -264 2 16.51 12.593 4.54035 -5.5475 22.5864 15.6708 -265 1 6.17495 10.0683 0.210584 -22.0037 -7.52033 -29.8636 -266 2 5.35839 10.4511 0.557392 5.20282 -1.85407 -1.83494 -267 2 6.76092 10.0813 0.943985 23.8798 0.550264 15.5383 -268 1 12.3644 6.05734 4.04236 -20.6788 -35.4367 28.6454 -269 2 12.4738 6.70802 3.38308 -3.94744 31.282 -24.9442 -270 2 11.4212 5.77124 4.03221 20.7152 8.11174 -1.23853 -271 1 0.124733 12.8266 0.203961 1.72956 2.54106 -4.3392 -272 2 0.029974 13.5935 0.786871 -3.06107 -4.47794 0.0529132 -273 2 18.185 12.9963 18.0877 7.84157 1.57112 5.96497 -274 1 3.83931 18.5785 8.61972 17.9182 -8.56599 -14.1766 -275 2 3.58625 18.36 7.70531 -6.70328 -0.941099 8.10721 -276 2 3.07994 0.282626 9.06556 -18.5101 7.20519 -0.527908 -277 1 7.37599 17.2741 4.45241 45.8101 34.7343 -2.7797 -278 2 8.02493 17.9603 4.76808 -26.0663 -25.3607 -1.65849 -279 2 7.47725 17.3636 3.49301 -12.8678 -9.31687 6.18264 -280 1 9.20909 17.0315 12.2197 44.1268 -5.71549 17.0535 -281 2 9.48765 16.172 11.8421 -16.3435 15.6721 -2.29993 -282 2 9.99892 17.2887 12.7762 -25.7988 -5.61825 -13.0657 -283 1 13.3284 13.0292 7.94175 -52.6762 -33.6944 -6.73328 -284 2 13.0533 12.253 8.47808 14.3801 9.17086 -2.06391 -285 2 14.1985 13.2855 8.14946 32.3912 12.3835 13.183 -286 1 14.9871 2.94126 15.3478 14.7752 10.8142 -9.8874 -287 2 14.2243 2.52816 14.9303 6.27209 -7.10728 -1.53608 -288 2 15.7054 3.02501 14.6718 -21.9622 -5.02255 13.6584 -289 1 9.85637 15.4939 17.0026 6.25802 5.34328 -5.30261 -290 2 10.2013 14.6312 16.7411 3.93948 4.67059 -1.18803 -291 2 9.35728 15.3668 17.8085 -8.94372 -2.90673 5.88613 -292 1 11.2848 8.23994 16.5492 3.15289 33.2939 2.2253 -293 2 10.8315 7.75123 15.8747 -9.91387 -14.5897 -7.3255 -294 2 11.7506 7.62533 17.1016 4.32393 -13.5731 6.91104 -295 1 3.77097 18.1898 16.7118 5.96936 32.6304 11.943 -296 2 4.24576 17.6768 17.3569 8.77088 -19.0197 5.38959 -297 2 3.7978 0.441972 17.1008 -3.8528 -14.6362 -12.0582 -298 1 2.20581 4.09889 8.95874 4.57905 1.19328 9.26631 -299 2 3.00197 3.55544 8.74643 -17.2537 17.4622 14.7611 -300 2 2.10364 4.24367 9.94001 11.4926 -15.28 -28.3391 -301 1 9.9196 10.3581 9.75231 -27.966 16.15 -17.0738 -302 2 9.34403 11.1055 9.40387 24.0849 -21.7639 18.0289 -303 2 9.87032 10.282 10.7171 1.16507 9.52838 -7.01624 -304 1 9.73405 0.807167 10.8572 18.2139 21.6835 4.91261 -305 2 9.58177 18.5811 11.2204 -14.9491 -12.8069 -2.84973 -306 2 9.10878 1.03014 10.1675 -9.37034 -6.01821 -3.77915 -307 1 9.18221 15.2247 10.2123 -19.1642 -10.2407 -19.6365 -308 2 9.04674 16.0847 9.7631 0.663926 -17.4388 12.4081 -309 2 8.3908 14.6843 9.94105 22.9839 14.6501 17.4764 -310 1 1.00316 9.27987 10.329 14.3691 -27.2472 -11.0896 -311 2 1.16727 10.1904 10.5724 12.779 8.1681 -2.56256 -312 2 1.84996 8.76119 10.1498 -30.7163 35.51 10.5854 -313 1 16.8004 4.89338 8.19813 23.5039 -12.6505 29.7165 -314 2 16.1748 5.31624 8.83318 15.8467 -9.35353 -17.5774 -315 2 17.4877 4.38941 8.71628 -29.2517 16.802 -13.3541 -316 1 14.6379 14.6893 0.402347 -11.159 -0.978579 14.7724 -317 2 14.9609 15.3376 1.05877 0.0769081 -12.0935 -6.53519 -318 2 13.9048 14.1906 0.841144 15.9383 15.9909 -14.4014 -319 1 3.51181 11.0525 9.63829 2.1739 12.5105 -11.7746 -320 2 3.41507 11.3617 10.5484 4.86707 2.92948 -3.5212 -321 2 3.25155 11.8076 9.06383 -0.0479228 -15.275 7.06779 -322 1 11.0289 10.8695 1.26208 17.169 21.0662 -6.34954 -323 2 11.1535 11.716 0.753779 -4.03889 -27.9068 14.1765 -324 2 10.1142 10.5923 1.16471 -3.02205 2.54599 -1.38039 -325 1 13.2239 7.06188 12.8977 -30.3793 3.52384 -4.06516 -326 2 14.1381 6.84046 12.8922 25.6531 -5.59605 1.27225 -327 2 12.7471 6.22139 12.9668 3.13335 6.34025 -4.15647 -328 1 9.62584 1.88878 0.937813 20.0839 -1.09549 37.2578 -329 2 8.77484 2.11506 0.623903 -26.2152 1.3675 -15.013 -330 2 10.1764 1.70882 0.191067 9.10224 -0.512606 -16.4895 -331 1 10.6054 13.537 4.7508 -3.45661 -5.20977 -1.23778 -332 2 11.3208 12.9359 5.04367 -5.78837 16.6981 -6.98771 -333 2 10.4128 14.1619 5.47507 11.2154 -13.4565 -5.70688 -334 1 14.2525 1.6915 10.8868 25.1006 21.2848 4.13062 -335 2 15.0842 1.26497 10.6465 -4.75627 -8.22365 -3.1417 -336 2 14.5069 2.62992 10.8824 -13.5101 -4.08816 2.36647 -337 1 14.6678 12.4248 11.7157 -12.7858 -12.3306 -9.5252 -338 2 15.5574 12.5766 11.3177 -24.032 -11.5318 -4.29299 -339 2 14.0022 11.9667 11.1187 32.4402 16.632 10.9337 -340 1 8.24065 5.08218 9.78509 -7.81525 41.6802 29.5679 -341 2 7.45364 5.10173 10.3836 16.236 -11.1581 -20.3292 -342 2 8.36822 4.22882 9.41503 -10.4798 -31.0118 -7.50393 -343 1 1.59893 16.8132 18.3262 1.78713 43.6046 -19.4726 -344 2 1.99225 17.1675 17.4932 -13.4068 -2.95443 18.1753 -345 2 1.72693 15.8931 18.2458 9.12037 -33.6792 3.80865 -346 1 1.43382 17.2563 15.3383 70.3372 -10.1908 -13.5082 -347 2 1.32309 18.1562 15.5759 -5.39176 26.6374 11.2222 -348 2 0.623143 16.841 15.3782 -64.6751 -20.2725 0.847241 -349 1 3.73599 5.55499 6.2196 -13.8181 39.8005 -2.84681 -350 2 3.32092 6.26594 6.76194 2.21889 -20.7758 -8.723 -351 2 4.19567 6.05321 5.52665 5.67395 -4.434 2.61268 -352 1 12.357 9.41487 14.1826 15.3987 -29.3966 1.09302 -353 2 12.9591 8.63784 13.9021 -33.8501 34.209 16.2235 -354 2 11.936 9.15457 15.0346 16.6427 1.77305 -15.4117 -355 1 4.0362 15.2647 6.90572 33.8672 24.728 -7.08093 -356 2 3.45744 16.0249 6.7945 -6.17655 -1.99751 -5.28974 -357 2 4.92941 15.6518 6.66696 -29.006 -22.9584 9.78444 -358 1 0.606517 8.56128 14.8606 9.39684 15.8059 -8.30397 -359 2 0.498099 9.52604 14.9437 -1.87135 -9.61679 5.58044 -360 2 1.28855 8.50016 14.167 -9.83185 -6.21013 7.33103 -361 1 12.9763 8.3683 10.3434 1.19405 4.03237 -29.9304 -362 2 13.7163 7.90436 9.89822 -7.22584 1.47622 17.5396 -363 2 12.9003 8.0957 11.2534 8.23718 -11.529 10.7869 -364 1 15.2983 7.63672 3.47583 -36.323 -26.5913 31.5529 -365 2 14.5024 7.10501 3.29647 15.7237 15.5958 -25.1442 -366 2 15.2922 7.47095 4.43335 26.8259 14.207 -3.84044 -367 1 17.3208 6.63818 0.028906 -16.9884 17.5938 -6.80353 -368 2 16.7479 6.05403 0.554933 4.15554 3.30118 -7.73843 -369 2 16.7141 7.27151 18.2009 11.1968 -20.2911 18.275 -370 1 8.79355 6.92545 7.84172 -17.9944 -26.8715 17.7017 -371 2 9.63968 7.32585 7.85068 34.0918 14.4557 -5.0304 -372 2 8.77688 6.39871 8.67404 -5.99252 8.25367 -18.4431 -373 1 12.3209 0.607808 1.1741 -9.70621 -1.67076 -6.18378 -374 2 12.995 1.15082 1.58835 11.8921 -6.95349 3.94176 -375 2 12.79 18.5825 0.66073 -1.23695 5.23567 5.50046 -376 1 5.68514 15.097 14.5145 3.67475 30.0662 -16.0184 -377 2 4.72797 15.1695 14.4772 -3.92865 -1.97247 7.85561 -378 2 6.02476 15.8935 14.032 -4.97132 -21.5573 17.6103 -379 1 3.822 6.53853 1.67803 9.4136 -3.73603 -11.0507 -380 2 3.54968 7.33117 1.17576 -2.2757 -10.4776 17.1213 -381 2 3.81642 6.7886 2.60252 -0.785086 8.11893 4.5328 -382 1 3.89262 11.6088 12.227 13.3033 3.31132 5.82178 -383 2 4.72051 12.1032 12.348 -1.72331 -9.21471 -1.78635 -384 2 3.26281 12.0921 12.7526 -14.3078 7.33513 5.3451 -385 1 5.45444 3.88172 15.8755 10.9934 63.7886 22.8921 -386 2 5.90627 3.24049 15.3708 25.1493 -29.4334 -15.1609 -387 2 6.11665 4.65725 15.9739 -37.1513 -37.4972 -5.17498 -388 1 14.4636 10.317 4.39501 8.04256 -17.7362 -43.5508 -389 2 14.9051 9.88853 5.13417 -2.05112 -4.59794 0.583625 -390 2 14.7084 9.81768 3.53446 -13.0506 20.827 46.8358 -391 1 7.94949 17.2895 9.24469 -12.4073 10.6503 -4.49958 -392 2 7.23447 17.5423 9.86969 11.4984 0.663317 -18.2334 -393 2 8.01085 17.8889 8.47627 -8.74254 0.310971 13.2931 -394 1 4.4986 14.4237 3.96317 22.7921 6.59984 27.2073 -395 2 4.89523 15.3318 4.14709 -15.7294 -33.8816 -1.82578 -396 2 4.80237 13.7713 4.67129 -10.4496 32.1184 -24.135 -397 1 14.3358 7.38467 15.7635 24.4704 6.70756 7.84838 -398 2 15.2401 7.23754 15.391 -26.2451 3.74497 13.7384 -399 2 14.4998 7.83446 16.6232 -7.00308 -11.7114 -18.5693 -400 1 2.86875 18.2246 1.90934 8.22952 29.9251 46.5059 -401 2 2.54447 17.7626 1.17928 -17.7355 -34.6574 -39.0362 -402 2 2.08284 18.4154 2.45796 15.223 4.61378 -9.70941 -403 1 7.96139 1.61197 4.52525 29.4796 -3.5692 28.5612 -404 2 7.4985 1.83317 3.72811 -4.47294 12.8461 -13.1797 -405 2 8.84188 2.051 4.57628 -23.8244 -8.06079 -10.6756 -406 1 2.69247 14.1251 17.7583 -39.7925 -12.5472 14.0506 -407 2 1.78944 13.8074 18.0556 30.3506 3.26472 -13.0537 -408 2 3.33089 13.517 18.1683 -2.67461 8.7222 -7.81087 -409 1 0.711797 1.68055 13.8626 44.8563 0.102291 -15.8697 -410 2 0.854596 1.56791 14.7929 -2.34617 -4.64243 17.7358 -411 2 18.4557 1.86826 13.7064 -36.5874 5.33291 1.35002 -412 1 4.5582 18.5986 13.9691 17.69 -10.1212 -17.3986 -413 2 5.37614 18.0918 13.7297 -17.5363 18.7277 11.6893 -414 2 4.4096 18.4453 14.9034 -4.80692 -4.44744 5.40837 -415 1 7.10973 0.453475 18.3742 -17.6731 43.6393 33.9394 -416 2 6.99644 0.098599 17.5235 3.55611 -15.5456 -38.0778 -417 2 6.34312 1.05085 18.5323 11.5496 -19.3687 -0.295067 -418 1 16.0934 18.4421 14.1505 -13.5696 -24.3411 -34.6818 -419 2 15.444 17.7866 13.7542 20.5302 26.3107 23.9987 -420 2 16.0379 18.4915 15.109 -11.2087 -0.403296 -0.42938 -421 1 10.1156 4.52417 16.2956 -63.5341 -10.6596 -28.1335 -422 2 10.9808 4.34247 16.5381 54.6034 1.03427 17.4186 -423 2 9.84863 3.69679 15.8473 1.5569 12.8802 9.55133 -424 1 15.8226 17.9425 4.41327 -12.7412 7.89699 33.5898 -425 2 16.5547 18.5732 4.53052 -9.15632 -3.64108 -2.38506 -426 2 15.1071 18.2295 5.06915 28.1993 -15.1976 -35.9746 -427 1 6.9246 17.3574 13.7412 41.9162 15.5861 -1.52717 -428 2 7.49648 17.8115 14.4369 -23.1807 -22.4309 -23.3681 -429 2 7.52703 17.1963 12.9658 -13.588 5.84324 25.6525 -430 1 13.2892 6.57209 6.73437 -45.0771 -7.84691 9.23056 -431 2 14.2146 6.66317 6.83486 35.9508 1.69852 -11.4068 -432 2 13.0394 6.38579 5.82242 8.43649 1.47489 -3.25235 -433 1 7.6616 2.3861 9.17526 8.07841 -8.24756 -37.8228 -434 2 7.32169 2.39592 10.0555 -17.554 -3.79201 20.6206 -435 2 6.95914 2.1022 8.53308 18.9972 7.96045 22.8376 -436 1 15.1464 14.8771 13.6482 -9.08859 5.19149 1.30171 -437 2 15.0308 15.0223 14.6069 -2.64384 -0.244686 -12.5428 -438 2 14.3194 15.1152 13.1798 15.9342 -4.32482 12.4068 -439 1 9.29105 8.34315 3.70472 25.3147 -22.6228 7.1656 -440 2 10.1776 8.75859 3.73678 -14.6049 0.788849 -0.227964 -441 2 9.48378 7.39942 3.88081 -7.38963 16.6026 -2.51653 -442 1 17.6854 13.4687 16.4528 1.20699 34.422 -16.619 -443 2 16.7357 13.4337 16.3398 -3.15338 -8.61752 5.60033 -444 2 17.8844 14.3284 16.0065 4.30498 -21.0483 11.9174 -445 1 5.04883 10.6547 2.58751 21.171 -14.0773 3.70172 -446 2 5.87017 10.3468 3.04382 -23.0848 5.17759 -4.78185 -447 2 4.55197 11.1441 3.22928 -5.68041 9.33128 13.9497 -448 1 3.70566 8.3683 10.3381 2.8322 -31.099 -4.13864 -449 2 3.86061 9.29726 10.2176 3.71195 18.7597 0.626964 -450 2 3.86652 8.14601 11.2715 -4.70232 11.1023 -9.34814 -451 1 16.1079 7.11641 6.33859 19.1617 -15.4194 -14.8444 -452 2 16.7241 7.70559 6.80408 -7.69122 -6.37409 -7.38138 -453 2 16.6678 6.33083 6.12136 -24.1396 12.8226 8.63966 -454 1 15.2027 7.00502 9.1117 -12.4455 33.5656 -30.1004 -455 2 16.009 7.42176 9.46585 -11.7729 -5.93044 -7.51071 -456 2 14.9881 7.51375 8.25647 14.3105 -22.443 40.0586 -457 1 6.4525 13.1649 12.9201 -14.4212 4.62434 6.2224 -458 2 7.2977 12.7289 13.0561 -0.519457 -3.7562 7.19322 -459 2 6.25327 13.7237 13.7059 9.03992 -10.4089 -22.4145 -460 1 12.1145 4.49786 13.0694 60.1541 40.3897 -0.599702 -461 2 12.3852 4.68406 13.9868 -12.8154 -8.572 -1.53547 -462 2 11.3952 3.9317 13.0199 -51.9002 -33.7145 4.15206 -463 1 11.3323 8.18365 7.8522 33.2694 0.481688 12.7059 -464 2 12.0901 7.73501 7.43634 -16.2057 -1.97452 -6.97761 -465 2 11.7651 8.45102 8.68662 -20.5523 -0.0583287 -5.01537 -466 1 17.1666 10.776 7.42179 36.6255 -17.1838 -28.5238 -467 2 17.7906 10.0723 7.08441 -19.5131 16.2155 23.227 -468 2 17.2793 11.4524 6.73733 -13.1225 1.2547 8.82205 -469 1 5.22802 18.1471 11.05 -26.218 -15.3265 2.15414 -470 2 4.73762 18.1049 11.901 9.27461 0.443739 -18.2338 -471 2 4.62535 17.7417 10.374 18.9971 14.5949 15.121 -472 1 7.56653 17.6363 1.80821 2.05543 -3.48119 51.3305 -473 2 7.65741 16.7768 1.42856 8.63412 -18.3953 -16.9352 -474 2 7.35855 18.2549 1.13994 -1.30452 14.3677 -27.7338 -475 1 1.85092 12.9256 13.6076 17.4877 19.0754 23.2488 -476 2 1.72104 12.4156 14.4258 -6.17153 0.259213 -13.4945 -477 2 2.19932 13.7866 13.9501 -9.51965 -23.6336 -9.57422 -478 1 9.73868 6.79159 14.8001 -20.4051 42.5069 -0.796717 -479 2 9.95236 5.95211 15.1529 11.7083 -38.3225 9.01974 -480 2 9.967 6.84408 13.8723 6.06139 -4.97285 -7.43337 -481 1 15.2087 4.3972 10.7794 -26.9028 -24.0998 -25.0358 -482 2 16.0082 3.89203 10.8637 24.0661 5.32644 6.50358 -483 2 15.2102 5.16148 11.3322 8.70888 13.5856 17.3899 -484 1 11.1963 6.12482 0.150068 -24.122 -22.6006 13.7234 -485 2 11.2381 5.20796 0.481504 11.6671 13.7026 -10.2768 -486 2 10.2374 6.21547 18.6186 16.3103 12.5014 -3.12394 -487 1 0.19533 11.3359 15.1413 -21.6592 10.769 -30.7731 -488 2 18.4021 11.874 14.3993 14.4722 -20.1415 31.2795 -489 2 18.4481 11.661 15.9631 4.68348 9.49999 -5.94609 -490 1 7.06882 9.13032 7.26059 -22.6631 -3.09615 15.424 -491 2 6.55985 8.40099 7.69941 15.0645 18.9564 -17.5163 -492 2 7.9725 8.82922 7.21375 6.85038 -6.33336 0.902711 -493 1 18.4578 15.4507 12.3537 6.97015 0.808933 -7.22971 -494 2 0.776651 15.5698 12.2511 -16.5258 -3.56518 7.28193 -495 2 18.1456 15.6789 11.4721 -4.11121 -1.28038 2.68538 -496 1 16.5694 4.36967 5.25107 2.45626 -29.8761 41.2812 -497 2 16.7744 3.81151 6.06026 -19.4928 29.4804 -23.4548 -498 2 17.3898 4.32671 4.78168 14.6436 6.44337 -19.6343 -499 1 17.788 3.06911 10.7078 8.19486 16.3181 17.0759 -500 2 0.075758 3.1322 11.0257 -18.3141 -4.46618 -10.1687 -501 2 17.6332 2.20749 10.3226 7.04824 -10.7221 -5.22745 -502 1 12.3142 0.064083 10.1758 -16.6046 52.5698 5.40656 -503 2 11.3746 0.384648 10.259 27.2889 -19.3162 -0.832384 -504 2 12.8178 0.919304 10.3228 -10.5773 -40.3011 -9.47381 -505 1 10.3666 9.83315 12.2981 15.5663 4.35939 24.9446 -506 2 11.1015 9.85063 12.955 -12.9587 3.49885 -14.3711 -507 2 10.1328 8.91188 12.2898 -2.48305 -14.5784 -4.85859 -508 1 0.463654 2.82678 7.01839 21.5285 29.229 11.0876 -509 2 0.875324 3.58845 7.48211 -15.1018 -9.47019 -10.8481 -510 2 0.770257 2.12665 7.58365 -2.10845 -18.3887 2.87796 -511 1 0.478371 15.2358 6.91004 -5.05906 -57.415 8.40739 -512 2 0.585298 15.6463 7.75647 1.85019 10.3725 13.8373 -513 2 0.556531 14.2524 7.18353 -2.63305 52.383 -27.2731 -514 1 16.9534 7.00251 15.3394 -15.9191 6.08615 -6.45156 -515 2 17.6338 7.63543 15.0899 14.1822 -6.8729 3.83609 -516 2 17.3093 6.19568 15.7235 10.8839 2.85836 -7.52482 -517 1 9.0001 12.4151 8.13768 -31.1102 30.9609 25.8163 -518 2 9.37386 11.8218 7.49742 -5.17233 -14.4246 -22.3971 -519 2 8.02402 12.632 8.03373 38.2843 -19.0142 -6.47162 -520 1 1.27238 1.95406 3.05803 -13.5483 -7.94682 -18.4152 -521 2 1.26084 2.61511 2.34121 0.274888 -9.5029 12.9388 -522 2 1.89031 2.22344 3.73293 6.76618 11.1556 -0.474465 -523 1 4.13907 15.1156 9.62039 -21.6353 8.89781 12.928 -524 2 4.07003 15.1439 8.65747 6.73796 -2.17255 1.87071 -525 2 4.96029 14.7006 9.86457 13.8731 -5.89958 -3.36363 -526 1 7.17628 2.17866 14.5671 10.1969 15.6665 0.500505 -527 2 6.99528 1.68402 13.7698 -5.58163 -4.27811 -6.1139 -528 2 7.62131 2.98432 14.249 -3.31044 -9.5634 8.35677 -529 1 18.6082 14.7131 2.1481 32.6395 -16.0207 -3.46113 -530 2 0.838003 15.1297 2.25966 -5.15041 -8.02703 -3.38947 -531 2 17.988 15.3544 2.42675 -27.9684 22.1971 4.74449 -532 1 9.94138 2.79524 12.9422 16.7157 -19.9527 -5.96647 -533 2 9.79404 2.1456 12.2228 -2.63367 12.9584 8.66897 -534 2 9.17835 3.36299 13.0326 -7.96092 5.51528 -6.54514 -535 1 2.80444 8.90955 13.0076 -17.7822 -13.1167 0.317539 -536 2 3.06361 9.80599 12.872 10.5962 22.9278 -4.25378 -537 2 3.5122 8.48618 13.4775 15.1932 -9.60442 7.00981 -538 1 3.236 8.3574 3.63664 -2.86765 -22.2709 68.2353 -539 2 3.45085 9.0718 3.07326 14.564 28.9211 -13.7717 -540 2 3.47645 8.58669 4.60794 -11.4307 -4.68562 -51.1711 -541 1 5.62853 7.18594 8.51094 8.63755 21.4894 2.16978 -542 2 5.46784 6.31815 8.13889 -3.95344 -9.53044 10.3317 -543 2 4.96415 7.47792 9.15047 -3.24726 -12.0183 -2.29801 -544 1 14.8757 1.26039 2.01768 8.95967 6.82752 -28.1452 -545 2 14.9353 2.01952 2.56559 -6.40438 15.8227 28.9683 -546 2 15.2784 1.60993 1.21235 -4.35761 -14.1118 -5.79377 -547 1 8.22892 15.2012 0.850139 10.8537 -12.6178 7.38979 -548 2 9.02213 14.9338 1.33488 2.38301 14.3333 -0.830013 -549 2 7.55366 14.6663 1.27665 -9.08858 2.03607 -6.2405 -550 1 15.6387 1.34587 7.23673 -38.2068 -12.1482 -8.38322 -551 2 14.9277 0.724731 6.91269 26.6184 17.4884 8.18161 -552 2 15.1173 2.1119 7.53894 10.4663 -3.86302 -4.52487 -553 1 4.90142 13.0959 18.5232 17.6249 -4.01801 23.9701 -554 2 5.32755 13.082 0.76977 -10.7656 0.632793 -19.6876 -555 2 5.44764 13.7122 18.0259 0.499955 -3.74815 -4.96885 -556 1 15.3368 8.46948 18.1479 21.2409 26.352 -19.7425 -557 2 15.8061 9.12264 17.5623 -15.5364 -21.5252 11.6976 -558 2 15.3318 8.91689 0.353875 -5.84476 0.442576 5.05054 -559 1 12.0708 3.01842 18.3809 -8.91332 38.2285 -17.9492 -560 2 11.9316 2.65996 0.60646 7.08072 -18.979 4.32412 -561 2 12.6022 2.47389 17.7995 4.78982 -18.1658 8.07002 -562 1 13.2139 12.6752 5.17768 -9.57044 10.0795 -9.57129 -563 2 13.7464 12.0348 4.69253 1.60656 -5.44915 8.62561 -564 2 13.2564 12.5123 6.11793 10.4898 -3.48459 7.66387 -565 1 6.05443 7.0356 0.031519 0.0605761 -19.9038 6.17744 -566 2 5.93935 7.95118 18.5019 3.71712 34.2187 -1.98634 -567 2 5.39095 6.86665 0.702638 -7.83388 -10.1683 0.476271 -568 1 17.7528 16.0276 15.0213 -25.9758 6.2762 6.79882 -569 2 16.9476 16.5457 15.105 3.54626 -1.67183 20.5845 -570 2 17.7479 16.0055 14.0813 22.8568 -13.146 -30.1028 -571 1 13.196 0.994907 16.5363 6.37162 1.07879 13.9702 -572 2 14.1481 0.997912 16.7614 -14.4757 -4.73392 -6.84542 -573 2 12.8833 0.094199 16.7238 3.07394 5.84273 -8.05351 -574 1 11.1253 14.5647 7.20271 13.6513 20.7581 -19.5035 -575 2 10.4007 14.3183 7.72981 -32.979 -9.13798 24.3252 -576 2 11.7186 13.8255 7.26943 15.8912 -3.80541 2.99114 -577 1 17.5081 8.62849 2.08107 17.5857 37.593 18.6886 -578 2 16.6801 8.63471 2.55495 -11.5266 -11.0229 1.73392 -579 2 17.5233 7.88242 1.516 -4.85302 -28.502 -20.2632 -580 1 12.3547 8.01168 2.02213 2.8693 7.47745 -2.1033 -581 2 12.2384 8.8582 1.54611 -1.5199 -14.1485 9.25757 -582 2 11.9739 7.3152 1.48261 -4.60849 0.564674 -12.802 -583 1 11.8761 14.6165 10.3364 -1.28632 -27.1744 -11.0444 -584 2 12.1004 13.7873 9.81464 -15.5434 34.4502 21.6186 -585 2 10.8993 14.6888 10.473 22.8986 -6.0814 -12.7032 -586 1 6.89524 7.05211 15.6117 2.70483 5.93472 10.8866 -587 2 7.81004 7.26536 15.3122 -19.1207 -0.823892 9.8847 -588 2 6.66676 7.54167 16.4408 15.3743 -10.0989 -25.4065 -589 1 8.00326 4.73593 13.4743 46.2088 18.1039 21.0673 -590 2 7.23337 4.7302 12.9572 -37.1051 2.19442 -26.1447 -591 2 8.40671 5.62958 13.343 -9.63909 -26.9075 5.20654 -592 1 13.4128 12.1818 14.2522 -5.46405 -2.8504 7.05596 -593 2 12.9414 11.3292 14.2657 10.1901 3.29349 -5.65079 -594 2 13.7875 12.315 13.3696 -1.58979 -2.51674 3.72795 -595 1 14.8395 9.42189 7.30548 -10.1492 -33.0314 -14.9507 -596 2 15.7087 9.765 7.42505 18.3001 17.1245 4.25051 -597 2 14.2269 10.0768 7.57319 -16.3703 19.68 11.0075 -598 1 12.6526 17.0686 3.07252 -25.5483 38.6692 13.4046 -599 2 12.8376 17.5237 3.93373 3.7914 -19.7635 -24.6942 -600 2 11.9913 17.6958 2.63477 29.3498 -30.5169 14.5322 -601 1 1.15545 7.13838 17.4647 -1.30818 10.8795 -24.4228 -602 2 0.330359 7.36323 17.9184 3.51096 -10.352 -1.0007 -603 2 1.05514 7.47868 16.5422 2.6229 -4.15873 21.1004 -604 1 12.7562 5.15096 15.6457 46.9745 -3.15458 16.4241 -605 2 13.4512 4.55662 16.0315 -23.8856 11.8204 -16.5269 -606 2 13.2414 6.00335 15.5788 -13.869 -10.6853 0.37407 -607 1 2.53993 3.38757 4.97618 -24.4059 44.0626 48.9955 -608 2 1.7609 3.18232 5.58922 29.5313 1.39757 -24.0522 -609 2 2.84154 4.31546 5.27885 -6.94106 -48.8689 -12.2378 -610 1 8.33186 11.2983 13.4548 -25.447 4.99647 44.923 -611 2 8.4244 11.0562 14.4444 7.04045 1.38295 -54.395 -612 2 8.91168 10.8786 12.8197 20.7237 -12.5345 14.2107 -613 1 12.8689 1.31514 13.3384 4.70567 59.9078 -15.5432 -614 2 13.42 1.58034 12.5659 -9.46235 -19.1343 13.2352 -615 2 12.4231 2.17844 13.5496 8.70338 -32.6779 -3.58081 -616 1 6.34008 13.7169 2.14963 -19.3306 -6.11379 22.757 -617 2 5.63978 13.877 2.82959 17.9638 4.85668 -21.8758 -618 2 6.88351 13.0442 2.56282 8.57629 -2.48731 -1.94932 -619 1 15.9206 6.61444 12.7992 -23.3103 -26.3741 2.68057 -620 2 16.3106 7.25195 12.2393 16.9755 20.6681 -18.7226 -621 2 16.4213 6.59661 13.608 7.79648 1.05266 12.4236 -622 1 16.8298 0.712824 9.59482 4.79811 -22.8344 -3.47194 -623 2 16.8791 18.3713 9.72616 -6.98639 26.8255 -1.99774 -624 2 16.5452 0.8605 8.67269 -2.39382 -2.67689 10.2173 -625 1 6.14624 11.7631 8.37671 0.189841 -56.9827 6.97012 -626 2 5.32447 11.4591 8.84151 16.7156 13.8425 -13.046 -627 2 6.64226 10.8931 8.20176 -19.0535 39.3101 2.14415 -628 1 2.88754 8.61261 0.453821 12.2401 -11.553 -23.675 -629 2 2.45212 8.04764 18.3917 -4.84247 31.247 26.7064 -630 2 2.34875 9.28564 0.895642 -13.4946 -8.81401 -13.4914 -631 1 10.1674 10.4623 6.50123 4.87464 -2.88608 -13.8248 -632 2 10.6087 9.69731 6.89122 -0.620763 2.00125 4.93232 -633 2 10.4694 10.4636 5.56932 -5.34739 2.02001 15.3519 -634 1 6.7142 15.6951 6.55167 22.995 7.84961 12.6004 -635 2 7.14328 16.1838 7.27089 -9.73558 -8.55589 0.364412 -636 2 7.21237 16.006 5.79102 -10.9792 5.43097 -10.3878 -637 1 6.445 13.1807 5.57797 -3.32019 -20.8794 2.06608 -638 2 6.7301 13.9465 6.07331 -1.80129 7.88671 5.96843 -639 2 6.09943 12.5433 6.22286 1.13913 6.90777 -2.85329 -640 1 16.8242 12.5629 9.83758 3.36613 -21.9924 0.476486 -641 2 16.9985 11.8651 9.16533 -5.29916 18.5903 6.02329 -642 2 16.5644 13.3844 9.42716 1.61266 3.35571 -10.8679 -643 1 6.03738 2.95058 2.86354 -7.51536 -24.4327 -2.00067 -644 2 6.40977 3.757 2.57075 14.9417 32.1903 -3.64532 -645 2 5.57703 2.61747 2.09059 -4.23441 -8.07329 -3.19257 -646 1 10.9114 3.33767 3.30112 3.4906 -2.16377 5.30702 -647 2 10.297 4.02722 3.58926 -1.61521 -6.66566 -5.52383 -648 2 10.5127 2.84524 2.57795 -5.77666 1.81375 -3.43243 -ITEM: TIMESTEP -10 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.68194 7.08301 17.95 -9.31723 -4.61569 5.17534 -2 2 7.78696 6.81626 18.2438 14.604 4.05464 -8.83536 -3 2 8.80373 6.759 17.0506 -2.23465 -3.10488 4.80291 -4 1 18.5422 8.2512 6.84005 -1.85374 20.2636 49.1182 -5 2 0.133718 7.9438 5.98823 13.4692 -17.0673 -32.1853 -6 2 0.402402 7.78616 7.5434 -4.29735 0.835788 -17.7519 -7 1 8.38516 18.5522 6.81414 18.1861 9.65042 -3.37417 -8 2 9.3349 0.126592 6.72298 -16.1755 -3.42506 1.43069 -9 2 7.92248 0.594936 6.31239 0.819355 -0.881225 3.09059 -10 1 6.59178 1.84314 11.71 32.0023 -4.98621 -11.2566 -11 2 5.89352 2.36713 12.0513 -24.1224 14.8358 13.0259 -12 2 6.19214 1.0378 11.3953 -8.69892 -12.638 -2.90229 -13 1 7.13386 5.75674 2.33026 -14.5408 0.616599 17.9391 -14 2 6.48306 6.1089 3.01881 22.5383 -2.3727 -34.6055 -15 2 7.09544 6.2305 1.47237 -10.8297 -1.47351 21.389 -16 1 16.2171 10.1491 16.1328 -28.1801 3.24526 14.6911 -17 2 17.0032 10.2274 15.6211 19.8027 8.68317 -10.1896 -18 2 15.8342 11.0337 16.2804 9.6716 -6.93987 -4.62354 -19 1 10.6069 15.0266 2.30703 -4.98248 -17.7421 -7.27467 -20 2 10.5595 14.4209 3.0573 0.524935 2.03122 3.93242 -21 2 11.0455 15.8043 2.63229 7.74565 12.2645 5.86516 -22 1 17.1614 8.24714 10.3877 8.07926 1.42828 6.48104 -23 2 16.5623 8.78009 10.9215 0.0316367 4.64377 2.31684 -24 2 17.9785 8.76022 10.2824 -6.97801 -4.40732 0.702868 -25 1 14.8935 15.8724 16.3278 20.2214 -7.01151 6.5945 -26 2 14.0152 16.2142 16.2283 -22.9266 5.478 3.03945 -27 2 14.9126 15.3591 17.1528 -4.85523 2.97165 -4.07838 -28 1 12.1655 13.3835 0.413391 7.36911 -14.3954 12.824 -29 2 12.1103 13.7323 18.1651 -6.85057 6.78658 -3.29346 -30 2 11.6807 13.9152 1.05851 -4.03153 8.23708 -7.75902 -31 1 9.27599 5.36662 4.05276 -29.4571 7.127 11.0843 -32 2 8.67176 5.26931 4.85064 22.4619 1.60875 -30.6294 -33 2 8.67539 5.53054 3.28716 9.26602 -4.36827 15.8404 -34 1 1.82909 4.27439 11.6483 -10.3032 26.7578 -2.81239 -35 2 1.73625 5.21877 11.9337 1.99226 -22.9368 -8.90994 -36 2 2.3645 3.83767 12.2983 6.89168 -8.93952 11.7704 -37 1 1.96701 6.83625 8.36791 0.700563 -10.6105 -3.76521 -38 2 2.46094 7.16371 9.10974 5.61647 13.7513 9.96296 -39 2 1.91553 5.8986 8.57777 -2.9792 -4.95164 -6.48224 -40 1 5.40472 4.39468 7.93775 -13.5219 -10.4794 -16.6571 -41 2 5.47247 3.43369 7.82443 4.19114 6.69916 9.09153 -42 2 4.75726 4.62849 7.24994 8.09624 5.59982 9.8174 -43 1 3.2394 2.92305 17.5474 -0.484589 33.1528 15.1222 -44 2 3.93082 3.31406 16.9898 -0.722116 -4.79924 0.441987 -45 2 2.93778 3.68549 18.1255 3.8058 -28.2307 -17.5498 -46 1 7.46921 5.27133 6.11017 -1.04832 -15.5011 48.3459 -47 2 7.90561 5.59719 6.92877 -0.90713 11.0324 -30.0179 -48 2 6.96076 4.54233 6.5205 0.0145083 12.7024 -20.8234 -49 1 9.7753 7.02229 11.9825 10.38 0.905424 28.7819 -50 2 10.3185 6.36588 11.5577 3.53671 -5.58238 -7.94156 -51 2 9.14507 7.32646 11.347 -14.6838 3.32198 -19.6076 -52 1 14.1071 3.54759 8.03608 -23.8038 4.02857 -21.7378 -53 2 13.5341 4.25359 7.68722 9.9361 -9.73972 0.838395 -54 2 14.4214 3.88758 8.85457 11.6 9.53944 21.926 -55 1 4.79933 17.2591 4.02624 -13.379 0.496236 -8.73431 -56 2 5.57386 17.851 4.10922 -16.5825 -9.69995 -7.24814 -57 2 4.20396 17.5018 3.27728 17.9024 3.63898 12.5287 -58 1 16.5033 16.6227 10.0525 8.55043 -2.52252 -17.4646 -59 2 16.0579 16.4137 10.8501 -12.2091 1.77219 28.6058 -60 2 15.9447 16.1927 9.39741 3.82195 1.69594 -5.2917 -61 1 1.95551 4.92482 0.485806 10.2127 4.96395 -0.662752 -62 2 2.54163 5.27617 1.19707 -10.7364 -3.48306 -18.9921 -63 2 1.87778 5.63364 18.4632 -0.0680824 -4.88148 10.5435 -64 1 11.8064 13.3616 16.2803 -11.2011 -32.854 -16.2783 -65 2 11.3068 12.5375 16.4476 0.201944 14.5536 10.5803 -66 2 12.2047 13.1237 15.424 4.38621 16.2025 8.43328 -67 1 10.1065 11.0626 16.9483 14.8798 -23.3813 0.89342 -68 2 10.5718 10.2022 17.1278 -15.1514 23.106 -6.44625 -69 2 9.22125 10.8281 16.6474 0.614925 -0.65596 2.44857 -70 1 11.7253 17.5378 13.4688 -9.94093 -22.0621 2.41868 -71 2 12.2582 16.9669 12.8891 0.443382 11.1567 2.15207 -72 2 12.0419 18.4322 13.3705 7.56806 8.72697 -4.32807 -73 1 6.34321 9.31538 12.2256 -11.115 -24.1278 -16.4431 -74 2 6.95505 8.9709 11.5438 -2.74015 10.4344 10.5225 -75 2 6.7633 9.99127 12.7388 17.4243 13.1424 4.46627 -76 1 16.2194 12.7233 2.70094 -4.61478 -5.953 2.95318 -77 2 17.0002 13.1906 2.44934 22.4693 3.83429 -6.00104 -78 2 15.5655 13.415 2.69545 -17.2672 7.42791 2.42646 -79 1 0.634553 12.563 5.85853 -28.5577 11.9856 -12.6208 -80 2 0.914444 12.5082 4.92832 1.43228 -1.32003 11.8657 -81 2 18.3286 12.8558 5.76638 29.2028 -10.3468 5.65715 -82 1 5.19236 16.3841 18.4962 26.3246 -0.931967 -7.14386 -83 2 5.89246 15.8922 18.0344 -14.3156 -2.38899 -1.49205 -84 2 5.72254 16.912 0.454606 -10.9177 5.22319 5.94171 -85 1 0.515157 7.6307 4.06432 40.0561 19.3507 -22.9165 -86 2 18.554 8.04388 3.41083 11.6748 -7.97607 10.9949 -87 2 1.4672 7.83805 3.73432 -48.6916 -7.92141 18.8197 -88 1 3.14333 8.89821 6.52388 -38.7347 7.47588 -5.16066 -89 2 3.55606 8.61579 7.33755 0.264066 -1.79724 4.80444 -90 2 2.15121 8.92424 6.67318 38.4004 -3.38228 -2.38687 -91 1 7.3156 10.3041 16.1747 -22.5262 4.44621 22.8692 -92 2 6.53394 10.4783 15.6406 9.03524 -0.350523 -4.2891 -93 2 6.93671 10.3234 17.0875 14.5541 -1.9474 -13.7178 -94 1 11.1094 1.06061 5.00017 -8.33223 -1.63593 -20.1003 -95 2 11.1653 1.90766 4.53999 7.02718 4.91961 9.72987 -96 2 10.7116 0.517103 4.29895 3.46448 -7.62041 12.1963 -97 1 4.44086 2.70257 13.2121 -8.76198 -6.25056 -12.8305 -98 2 4.61839 3.20254 14.0253 0.411253 -15.6801 0.294236 -99 2 4.37598 1.71769 13.3483 2.92355 28.3656 12.0639 -100 1 8.41481 10.0299 1.78755 2.58083 -12.9704 20.4417 -101 2 8.40154 10.6596 2.53141 -0.930044 -1.16348 -6.83089 -102 2 8.61337 9.15635 2.20556 -3.35942 21.7495 -11.7521 -103 1 10.5245 1.75336 15.553 -8.62776 -1.95945 -5.61675 -104 2 11.4377 1.70086 15.8172 12.2485 -3.82632 7.39579 -105 2 10.5516 1.84495 14.595 -9.16331 1.82149 -1.12185 -106 1 2.77042 12.9421 7.75317 -7.76237 -6.33315 7.0975 -107 2 3.33238 13.5624 7.27685 -2.67968 -0.352894 -3.41328 -108 2 2.03777 12.7029 7.16368 7.79305 2.46945 -1.53229 -109 1 3.64399 11.6862 5.32015 -16.8384 -12.8234 -6.75612 -110 2 3.34983 11.0669 6.0167 8.99611 10.2661 -11.4747 -111 2 2.85416 11.8487 4.76712 13.6242 -0.0526402 5.20338 -112 1 6.87773 14.4784 16.8504 -8.96924 2.55968 -2.39612 -113 2 7.58262 13.8601 16.6681 3.90388 -1.06505 3.99858 -114 2 6.56163 14.7581 15.9821 -2.66358 -1.99085 3.97159 -115 1 14.1744 14.5416 3.41044 10.3942 -0.651763 -8.74467 -116 2 13.655 15.3132 3.20132 -4.79611 11.1016 -3.67227 -117 2 13.7666 14.1672 4.18264 -6.53868 -10.5118 9.50782 -118 1 8.26761 18.1769 16.0723 60.4333 -9.62543 6.95109 -119 2 8.90915 17.473 16.3173 -32.2452 -3.35667 -3.16806 -120 2 8.92378 0.250762 16.016 -23.6515 10.2222 -7.97846 -121 1 4.73314 1.61844 4.90498 10.4838 29.1168 -20.5116 -122 2 3.92346 2.13642 5.08344 11.5633 -7.75976 -5.77828 -123 2 5.26159 2.15735 4.23518 -22.3286 -21.1319 29.8735 -124 1 15.1246 12.8394 16.4387 17.4381 -4.51065 31.9511 -125 2 14.6778 12.9897 17.2989 -1.10989 -1.43715 -21.8055 -126 2 14.5277 12.6911 15.7205 -25.4533 -1.78625 -11.0751 -127 1 15.7863 18.3852 16.7922 25.908 13.3822 31.678 -128 2 16.4574 18.6243 17.5189 -32.4234 -15.7026 -31.1655 -129 2 15.6278 17.4293 16.8067 2.01305 5.51074 5.25351 -130 1 1.13886 1.13555 16.5514 1.07915 19.6556 20.6288 -131 2 1.93696 1.57732 16.8903 -4.88731 -5.90564 -11.4186 -132 2 0.480719 1.50241 17.171 6.36092 -10.7053 -11.3623 -133 1 18.0845 4.58532 15.87 11.914 -13.2929 -3.66508 -134 2 18.5793 3.94883 15.3177 -8.66069 11.808 8.70591 -135 2 18.5822 4.70936 16.6848 -0.518448 -1.56194 -3.55701 -136 1 12.2302 16.9486 16.128 -37.9176 -11.5423 26.3029 -137 2 11.3914 16.5899 16.5469 36.4287 7.40626 -6.62059 -138 2 11.916 17.193 15.2634 5.93841 3.5336 -18.1806 -139 1 15.8788 2.54988 17.9721 5.087 5.67773 0.124923 -140 2 15.7549 3.4391 18.3687 -1.45045 -15.8437 -11.8457 -141 2 15.6801 2.58174 17.0093 2.38633 7.36977 18.7833 -142 1 6.70786 13.8001 10.254 -2.60372 -2.62943 9.53833 -143 2 6.60649 13.5148 11.1732 2.18143 10.2669 -0.00882184 -144 2 6.57676 12.9909 9.76432 1.5038 -4.69959 -12.8892 -145 1 10.141 18.2121 2.80409 9.87418 27.4677 -18.8777 -146 2 10.2555 0.291999 2.14056 -0.137226 -16.5556 14.9505 -147 2 9.2689 17.8819 2.61553 -12.127 -4.1331 -0.131977 -148 1 2.97228 17.7542 6.06181 -6.28377 0.301135 37.0401 -149 2 2.07671 17.601 5.72694 10.6784 2.25774 -14.0772 -150 2 3.63482 17.801 5.37776 -0.270923 -2.52512 -18.6151 -151 1 12.5659 17.001 7.96656 -23.415 -18.3905 24.197 -152 2 11.9071 16.2804 7.97312 11.7411 4.46809 -11.7089 -153 2 12.3405 17.4671 8.78984 12.2149 7.72109 -10.0441 -154 1 14.887 15.2779 8.2893 -14.8827 1.47652 2.73183 -155 2 14.0296 15.7117 8.25541 -5.1427 0.792443 13.0916 -156 2 15.1979 15.4906 7.42354 24.2513 -3.00083 -20.068 -157 1 17.5454 18.3111 0.374663 -13.7707 -4.14946 -2.00055 -158 2 18.2555 17.754 0.11924 20.0055 -25.3354 -15.9225 -159 2 18.0059 0.295965 0.896687 2.592 26.2966 16.2474 -160 1 0.909555 10.373 1.4127 -25.0541 -38.6286 23.1399 -161 2 0.0989843 9.87796 1.71715 28.402 10.794 -7.01331 -162 2 0.540787 11.0804 0.922273 -7.26144 30.0328 -22.846 -163 1 1.56438 12.1819 3.32547 9.10171 15.3717 9.49092 -164 2 1.376 11.5384 2.66679 -5.32309 -27.3061 -8.25977 -165 2 1.61002 12.9703 2.79202 3.36268 15.5511 3.76031 -166 1 0.549815 17.2556 4.8751 10.3167 15.4421 -19.2536 -167 2 -0.00199658 17.9163 5.26632 -10.5855 22.2192 -2.30371 -168 2 0.434878 16.519 5.43169 0.723696 -37.6018 20.4622 -169 1 1.10394 1.00198 9.3932 22.7427 9.86492 -7.57605 -170 2 1.42144 0.685439 10.2466 -8.09769 -6.36772 6.76546 -171 2 0.213433 0.697197 9.27667 -15.9263 -9.88137 4.21803 -172 1 16.7947 2.33275 13.2864 3.73194 4.84267 -27.3174 -173 2 17.0439 2.54012 12.3481 -6.98409 -4.39606 26.1758 -174 2 16.4729 1.42155 13.294 0.162444 -0.657512 2.21945 -175 1 2.4659 15.8297 12.1956 27.3811 -11.2673 13.1923 -176 2 2.9226 15.5311 13.0144 -9.82996 7.11615 -19.573 -177 2 2.93231 15.4201 11.4444 -5.86947 6.23921 4.54204 -178 1 16.4361 15.5441 5.94616 -3.08145 19.3328 -8.8947 -179 2 17.3593 15.4783 6.2724 -11.5576 7.7283 -8.52746 -180 2 16.3183 16.2893 5.29043 11.1937 -18.2696 22.1006 -181 1 5.84475 5.01999 11.7951 -3.08481 -3.45829 -4.75382 -182 2 5.52388 5.87345 12.0737 0.2772 11.9484 7.56792 -183 2 5.11411 4.43946 12.0133 1.47645 -8.9756 -0.689037 -184 1 15.224 4.86392 0.726277 -25.4938 -12.7349 25.4219 -185 2 14.7355 4.51715 1.53205 23.492 12.9767 -22.6649 -186 2 14.5328 5.02763 18.7193 1.17802 2.78752 1.94947 -187 1 16.3449 16.2967 2.11437 10.483 7.37611 -22.6614 -188 2 15.9997 16.7982 2.83675 -10.4405 6.50893 22.1211 -189 2 16.6677 16.9984 1.52582 -1.93062 -9.0043 0.169523 -190 1 0.302094 4.87802 3.79689 -13.2533 37.9479 3.00012 -191 2 0.313912 5.8808 3.95538 6.86913 -44.9842 -7.10747 -192 2 1.1462 4.49233 4.0346 3.71094 3.5442 4.02727 -193 1 2.9221 14.9895 15.0397 8.46471 -6.33736 14.5665 -194 2 3.00495 14.6058 15.9566 -9.31495 16.4585 -22.1508 -195 2 2.45729 15.8402 15.0938 1.85721 -3.29548 9.95349 -196 1 1.12 14.5717 9.56227 17.989 48.8934 -19.0037 -197 2 2.07414 14.5222 9.32346 -20.956 -13.4859 7.84449 -198 2 0.791626 13.7731 9.9282 4.87275 -29.8773 11.3577 -199 1 13.6624 16.6636 11.5457 -10.5327 9.77879 -22.0557 -200 2 13.3286 17.4311 11.0186 6.18992 -14.9435 17.5347 -201 2 13.3805 15.8992 11.021 -2.34987 0.215756 7.80532 -202 1 4.73359 1.47857 0.718618 -25.3973 -6.06392 2.87887 -203 2 4.17185 2.00661 0.129453 7.95287 0.81937 2.61464 -204 2 4.09095 0.858388 1.12753 14.212 5.94905 -1.43657 -205 1 1.42476 18.4735 11.9056 -5.99404 19.5083 -8.93412 -206 2 1.23513 0.382953 12.6723 -0.378912 0.915416 0.341246 -207 2 1.89505 17.7259 12.2433 7.21066 -16.1249 4.04173 -208 1 11.5448 10.106 4.11346 25.2596 15.8213 -25.5125 -209 2 11.5283 10.5663 3.22641 -2.70186 -14.3529 26.6987 -210 2 12.5027 10.081 4.37886 -27.2068 -0.404219 -8.52489 -211 1 8.37485 12.1748 3.75184 -11.9448 24.9759 46.3975 -212 2 9.17743 12.5878 4.11803 1.10724 -8.54244 -18.9118 -213 2 7.75197 12.4339 4.49102 7.61965 -18.0915 -33.0697 -214 1 14.3244 4.03247 3.293 11.3964 4.48411 20.4985 -215 2 14.943 4.18459 4.05162 -10.8147 -3.75721 -20.4981 -216 2 13.4909 4.45368 3.55282 4.29688 -1.92648 -2.70238 -217 1 5.58313 1.77339 7.50694 -37.3093 -46.6507 29.7736 -218 2 4.97145 1.12464 8.0478 36.2685 39.0776 -31.448 -219 2 5.37556 1.59155 6.57949 1.79923 3.69516 -0.386563 -220 1 17.9058 1.11523 4.88403 9.14173 18.8744 -7.73144 -221 2 18.4454 1.57607 4.20954 -6.0377 -15.1011 6.62684 -222 2 17.7347 1.81107 5.53023 -2.74058 -7.94095 2.09707 -223 1 6.8279 9.39776 4.48823 3.62694 -0.974221 -6.28613 -224 2 6.84568 9.51125 5.43283 -7.5389 4.30482 14.2207 -225 2 7.717 9.07508 4.31798 2.90721 -0.358573 -8.96695 -226 1 2.70207 14.9601 1.96467 9.48597 -9.94138 -22.1344 -227 2 3.35633 14.7518 2.62888 0.238693 -0.206349 10.2383 -228 2 3.16249 14.7444 1.12616 -13.7934 7.99556 12.9651 -229 1 17.2754 12.8959 13.1352 7.09139 -37.5845 3.69594 -230 2 16.3537 13.1102 13.3148 3.80173 19.6017 -1.81888 -231 2 17.838 13.6507 12.9698 -8.26303 20.1956 -1.14982 -232 1 15.0171 10.5799 1.38486 -27.8548 -28.8799 -20.6854 -233 2 15.5438 11.2121 1.82149 21.7425 28.5078 17.6295 -234 2 14.2994 11.069 0.967203 2.72678 -1.55793 4.42244 -235 1 5.71388 6.94387 4.52744 5.06868 -23.5408 12.0019 -236 2 5.87421 7.87915 4.41499 3.45829 8.88765 -0.888191 -237 2 6.40286 6.63416 5.14703 -8.303 0.627238 -7.76707 -238 1 8.10838 8.26645 10.1831 -2.58942 7.80898 11.2224 -239 2 8.62669 8.8788 9.66253 10.4484 9.83111 7.1505 -240 2 7.63286 7.80673 9.50478 -12.057 -13.4779 -6.03182 -241 1 13.5281 18.2914 5.80176 -22.4215 -1.8227 14.6872 -242 2 12.749 0.212336 5.63336 9.50875 -1.85743 -1.68773 -243 2 13.2346 17.7232 6.55015 8.07385 12.1374 -16.5266 -244 1 0.320637 2.55746 0.113707 -24.4854 52.0087 1.52013 -245 2 18.0083 2.70852 18.6241 7.28296 -16.9077 1.12853 -246 2 0.626424 3.4996 0.197011 8.79214 -31.4205 1.87945 -247 1 12.6453 10.9632 9.76861 -25.4211 42.834 -14.9231 -248 2 11.6492 10.8795 9.70071 37.3368 -7.50244 3.90461 -249 2 13.0228 10.1402 10.0352 -3.08107 -28.1376 6.91694 -250 1 0.78452 12.2807 11.0864 19.7349 -6.9692 -1.93691 -251 2 18.4749 12.3028 11.1225 -11.4863 3.49833 6.83674 -252 2 1.15231 12.659 11.9029 -10.6903 -3.95248 -3.68276 -253 1 5.04293 7.22507 13.482 3.09598 5.99749 -4.73795 -254 2 5.58886 7.93262 13.132 -0.232718 7.71962 -10.0141 -255 2 5.52798 7.00144 14.2755 -0.932575 -7.50807 9.86229 -256 1 1.28071 6.97469 11.8373 -31.3117 -37.3004 -11.5925 -257 2 0.492113 7.17802 11.3051 9.94401 -3.39318 6.90536 -258 2 1.685 7.80152 11.9673 18.2328 34.095 8.03536 -259 1 15.4541 9.47192 12.3133 5.85738 22.5951 5.06509 -260 2 15.5175 10.4638 12.3742 -4.62374 -31.0112 4.63394 -261 2 15.4968 9.06746 13.1992 -1.35817 12.6181 -10.5463 -262 1 16.6442 12.9519 5.45538 -21.4717 15.277 -31.3145 -263 2 16.3435 13.8787 5.41602 10.8128 -9.57177 19.5795 -264 2 16.428 12.7198 4.52965 10.5011 -15.0883 17.3079 -265 1 6.17539 10.0558 0.19339 -10.2788 -9.80575 -26.1597 -266 2 5.38875 10.4515 0.589333 6.07089 -1.52504 2.9393 -267 2 6.86188 10.0925 0.84877 11.0601 2.17112 10.8149 -268 1 12.366 6.05676 4.0416 -22.1854 -19.7968 12.9024 -269 2 12.3704 6.78834 3.44644 3.0333 22.1434 -14.5586 -270 2 11.4296 5.77117 4.03801 16.8285 0.174707 3.6691 -271 1 0.132536 12.8255 0.204274 -0.526736 3.63462 -3.55478 -272 2 -0.0162245 13.5547 0.824079 2.12041 -2.82991 -1.20796 -273 2 18.2367 13.045 18.0704 5.31007 -1.26571 4.82883 -274 1 3.83823 18.58 8.61434 -10.0824 -4.97514 -18.4016 -275 2 3.52069 18.2861 7.74382 9.30441 -4.40092 2.94392 -276 2 3.03757 0.306881 8.974 -6.88025 7.19874 10.2509 -277 1 7.39362 17.2775 4.45212 12.7302 8.58303 13.7229 -278 2 7.99666 17.968 4.81801 -14.6435 -15.1886 -20.2263 -279 2 7.36047 17.3088 3.48385 6.79225 7.50625 8.12072 -280 1 9.21958 17.0373 12.2266 15.7968 3.09867 9.11932 -281 2 9.35553 16.2013 11.7334 2.65662 13.4997 9.89778 -282 2 10.0046 17.242 12.8046 -16.9951 -13.4125 -19.4407 -283 1 13.3157 13.0082 7.94027 -17.3901 -31.9016 7.67948 -284 2 13.1929 12.2449 8.54147 -2.27359 6.97807 -8.06923 -285 2 14.1396 13.3907 8.1966 15.275 17.864 3.60781 -286 1 14.9833 2.94943 15.3513 6.95235 -3.03472 -25.2367 -287 2 14.3042 2.39498 14.9448 0.627233 -0.993788 8.39197 -288 2 15.6656 2.99789 14.6444 -10.442 2.78752 17.6131 -289 1 9.85751 15.5027 17.0048 6.47201 6.54967 -7.92386 -290 2 10.2825 14.6779 16.7304 0.0104739 2.25127 2.62159 -291 2 9.29444 15.3215 17.7618 -3.54568 -3.88732 3.90928 -292 1 11.2881 8.2507 16.5469 4.08161 11.4658 1.26949 -293 2 10.784 7.71518 15.9432 -10.4144 -1.78397 -10.2593 -294 2 11.7122 7.60386 17.1014 6.56418 -3.83522 10.5232 -295 1 3.78473 18.1936 16.723 -4.68023 16.7202 -12.0174 -296 2 4.25527 17.5912 17.2966 7.9068 -1.91441 12.6846 -297 2 3.78787 0.451609 17.087 5.31404 -15.3334 2.54941 -298 1 2.1979 4.10843 8.95106 26.9406 -12.5237 33.2314 -299 2 3.04044 3.62982 8.81286 -17.1971 13.1508 -10.8815 -300 2 2.16124 4.09638 9.93984 -10.9226 5.8942 -24.7105 -301 1 9.90906 10.3512 9.74092 -24.4032 35.3078 2.18412 -302 2 9.42476 11.1784 9.45919 17.314 -27.1904 0.11143 -303 2 9.91744 10.4013 10.7102 5.12409 -5.92526 -7.2544 -304 1 9.73754 0.812356 10.8589 -9.45704 -2.93658 -4.01088 -305 2 9.44076 18.5949 11.1517 4.40065 -9.39685 13.0528 -306 2 9.08713 0.996724 10.1835 0.761981 14.6946 -8.69624 -307 1 9.19301 15.2105 10.2107 -22.2036 -10.0383 -7.82623 -308 2 8.98025 16.0713 9.80369 1.46967 -14.8527 4.99479 -309 2 8.36662 14.6679 10.1029 23.0402 13.9843 6.10558 -310 1 0.991303 9.28993 10.3284 48.5242 0.758788 -7.3086 -311 2 1.23965 10.2015 10.4879 -14.9681 11.3684 1.41472 -312 2 1.89881 8.9146 10.1688 -36.1698 0.796544 3.16897 -313 1 16.8183 4.88742 8.19443 14.5542 -10.1877 33.2312 -314 2 16.1728 5.34475 8.77937 11.7085 -6.30946 -17.3069 -315 2 17.4003 4.3619 8.8005 -18.9368 13.5764 -18.1776 -316 1 14.6428 14.6932 0.395223 -8.43601 -1.47433 8.87339 -317 2 15.0319 15.2579 1.0921 -3.12605 -9.09789 -8.18687 -318 2 13.8519 14.2576 0.787234 16.4944 11.1317 -8.84191 -319 1 3.51972 11.0527 9.63241 -0.0258339 11.398 -8.76826 -320 2 3.50143 11.4368 10.5206 2.13389 -0.105265 -4.21661 -321 2 3.1724 11.7459 9.02999 3.72912 -11.0816 8.2725 -322 1 11.0404 10.8634 1.27208 6.70694 17.4362 -9.49329 -323 2 11.1727 11.6824 0.735781 1.31404 -20.4369 14.6488 -324 2 10.1116 10.6362 1.15363 0.362803 -1.95542 1.92755 -325 1 13.2201 7.06705 12.8916 -20.9652 2.88797 -6.38338 -326 2 14.1438 6.85164 12.9216 15.9393 -3.58362 1.12932 -327 2 12.7477 6.22232 12.897 3.28641 3.49729 -0.863357 -328 1 9.62872 1.89177 0.948251 6.96093 0.24991 16.0649 -329 2 8.76715 2.00519 0.577625 -19.1552 -2.18542 -3.65809 -330 2 10.1854 1.76875 0.19003 12.4655 1.79214 -8.44775 -331 1 10.594 13.5319 4.7375 16.0423 -1.41644 13.6035 -332 2 11.415 13.0379 4.93682 -11.8157 3.93147 -13.4525 -333 2 10.5255 14.1008 5.52348 -3.94863 -4.31219 -11.1546 -334 1 14.2685 1.70153 10.8945 -3.08057 3.85383 7.15216 -335 2 15.0552 1.23258 10.5836 3.50278 10.8149 -1.53255 -336 2 14.4104 2.66429 10.8947 7.37053 -8.35752 -2.77651 -337 1 14.6611 12.4198 11.7249 1.4364 -26.5965 -56.3444 -338 2 15.4897 12.4837 11.202 -5.7241 6.85295 22.6084 -339 2 14.0924 11.9909 11.0313 1.01548 12.4899 31.9742 -340 1 8.24953 5.08668 9.79072 -30.3058 0.287699 22.814 -341 2 7.41708 5.03925 10.3073 16.545 17.0491 -5.32162 -342 2 8.22462 4.2143 9.42755 11.9131 -18.3304 -16.4659 -343 1 1.59402 16.8187 18.3253 -6.20255 31.6963 -6.78121 -344 2 1.91227 17.2067 17.482 -4.95179 -10.2412 13.7563 -345 2 1.83336 15.9037 18.3179 8.32765 -17.6711 -3.36436 -346 1 1.43897 17.2464 15.3358 29.6054 -7.17934 -6.21787 -347 2 1.36087 18.1379 15.637 5.97318 20.4573 7.89508 -348 2 0.556137 16.9475 15.3273 -33.612 -15.1267 -3.09538 -349 1 3.72895 5.57357 6.20543 -8.92972 12.8219 1.61975 -350 2 3.23079 6.21113 6.76482 10.0758 -7.74032 -14.0976 -351 2 4.28418 6.06511 5.5772 -4.67021 4.78615 6.0759 -352 1 12.3529 9.4251 14.1822 19.6727 -43.1834 10.5387 -353 2 12.884 8.61082 13.8993 -22.621 36.8155 4.19437 -354 2 12.0516 9.14148 15.0731 3.60544 11.6456 -14.396 -355 1 4.03531 15.2728 6.90881 24.4865 3.71204 -3.62934 -356 2 3.44033 16 6.68284 5.60112 1.73001 -3.29651 -357 2 4.96253 15.5542 6.68078 -28.8575 -4.96404 7.1648 -358 1 0.605953 8.56457 14.8638 -0.120582 -0.391313 3.99343 -359 2 0.501042 9.52227 15.005 5.35221 -7.46858 -4.68281 -360 2 1.25554 8.44629 14.1506 -6.09669 6.93914 6.70414 -361 1 12.9734 8.36578 10.3368 20.5003 -18.2509 -7.79226 -362 2 13.7393 7.86937 9.99522 -8.8873 10.1321 -9.444 -363 2 12.9708 8.03443 11.231 -10.3099 3.90117 14.6287 -364 1 15.2894 7.6332 3.49269 12.7581 18.2329 -13.143 -365 2 14.5338 7.17315 3.08677 6.1918 -0.800492 21.6775 -366 2 15.5136 7.51531 4.43453 -15.4019 -14.7068 -6.3771 -367 1 17.3212 6.64473 0.0316567 -27.1824 12.6283 -1.8657 -368 2 16.771 5.99448 0.499966 9.26154 0.672542 -4.32476 -369 2 16.64 7.24337 18.2783 17.9792 -11.5061 8.92142 -370 1 8.80668 6.92454 7.83918 -24.3908 -17.2325 7.20576 -371 2 9.68081 7.28212 7.80962 25.7376 5.86496 2.86911 -372 2 8.71775 6.37228 8.64787 6.10597 9.33115 -12.275 -373 1 12.3202 0.615137 1.17425 13.6931 -3.72396 -2.19539 -374 2 13.075 0.992886 1.63957 -0.40119 2.44364 5.09949 -375 2 12.7571 18.5667 0.666384 -10.9298 0.853201 -1.96514 -376 1 5.6785 15.1027 14.5126 8.23045 15.6484 -5.86338 -377 2 4.72039 15.1784 14.5966 0.299323 4.01186 0.94539 -378 2 6.04535 15.9236 14.1081 -12.4379 -14.8055 10.7649 -379 1 3.83406 6.52943 1.68496 -5.12703 10.9404 0.999964 -380 2 3.44824 7.31709 1.2662 3.88585 -11.3877 -2.55221 -381 2 3.84338 6.82178 2.59771 5.33619 -6.06857 7.79227 -382 1 3.88904 11.6132 12.2401 8.95627 -8.79814 -2.40389 -383 2 4.75841 12.0277 12.3683 -7.0992 0.0294616 4.018 -384 2 3.233 12.1226 12.7151 -2.84239 9.6423 6.84851 -385 1 5.44987 3.87776 15.8711 9.04603 51.7105 12.2927 -386 2 5.99752 3.20763 15.4917 15.5436 -17.9801 -7.19396 -387 2 6.04703 4.69158 15.9698 -28.7283 -34.9666 -5.01916 -388 1 14.4605 10.3225 4.39641 11.4537 -30.5762 -31.9722 -389 2 14.8306 9.83502 5.14205 -5.39586 2.29688 2.9797 -390 2 14.6901 9.75629 3.58792 -12.4512 26.4694 34.1579 -391 1 7.94485 17.2962 9.23406 -29.3852 32.3044 -4.90329 -392 2 7.20157 17.582 9.8013 11.6936 -12.8295 -3.21694 -393 2 7.93254 17.9646 8.52624 8.85814 -10.3239 0.926379 -394 1 4.49873 14.4249 3.9575 27.1774 17.1098 41.9883 -395 2 4.83669 15.3326 4.20793 -17.2661 -25.1881 -14.2087 -396 2 4.80599 13.8528 4.71739 -13.53 13.4591 -29.2523 -397 1 14.3284 7.3854 15.7629 16.5671 6.07561 9.97379 -398 2 15.2454 7.23106 15.4511 -19.609 3.15959 8.32151 -399 2 14.4426 7.80786 16.6389 -4.4507 -8.27801 -15.1382 -400 1 2.87403 18.2247 1.90389 13.9577 30.3231 32.1513 -401 2 2.546 17.6397 1.25326 -17.0615 -24.6646 -23.5795 -402 2 2.12038 18.5502 2.43008 9.19244 -2.23706 -9.85686 -403 1 7.96361 1.60549 4.53489 27.0952 14.1367 0.307488 -404 2 7.49638 1.9472 3.77739 -15.4877 0.180801 -4.55719 -405 2 8.8215 2.06687 4.46869 -11.5471 -13.5362 7.94734 -406 1 2.67177 14.1298 17.7578 -32.0965 -17.6674 6.84649 -407 2 1.82063 13.6639 17.9969 26.9839 12.0838 -7.18622 -408 2 3.38659 13.5743 18.1098 -5.52669 6.70603 -3.66321 -409 1 0.723551 1.68725 13.8621 17.7332 3.27009 -2.43746 -410 2 0.829271 1.51069 14.7908 7.98206 -4.95309 12.0999 -411 2 18.44 1.84118 13.7764 -20.4783 4.25661 -8.09669 -412 1 4.55406 18.6 13.9636 17.2604 -7.63309 -9.35161 -413 2 5.43897 18.1924 13.8214 -18.4623 11.1021 3.79828 -414 2 4.32329 18.399 14.8757 -4.15164 0.0521115 2.41255 -415 1 7.10455 0.474046 18.3679 -11.2359 27.2348 29.1061 -416 2 7.12016 0.115813 17.4965 -1.63433 -6.1865 -23.0052 -417 2 6.24271 0.910062 18.5515 12.5771 -12.8936 -7.91243 -418 1 16.1005 18.44 14.1333 -36.4501 -27.5791 -6.57953 -419 2 15.3829 17.8174 13.8465 25.6281 20.8019 -1.7164 -420 2 15.9077 18.5395 15.0719 9.49834 8.44163 -0.14337 -421 1 10.1046 4.52059 16.2893 -46.9792 2.1543 -16.8809 -422 2 11.0012 4.49779 16.5541 31.7343 -4.51398 5.87687 -423 2 9.86248 3.65729 15.9089 12.0807 6.21086 8.83226 -424 1 15.8363 17.9271 4.41684 -16.1004 8.03032 22.5493 -425 2 16.5039 18.6299 4.52246 -8.60661 -6.24751 -1.3813 -426 2 15.0378 18.2098 4.9532 29.0614 -11.0784 -22.6438 -427 1 6.9284 17.3613 13.7353 43.359 11.4946 7.60179 -428 2 7.46858 17.7163 14.5015 -21.3841 -13.8198 -23.6549 -429 2 7.59514 17.216 13.0184 -16.6797 3.36376 18.1603 -430 1 13.2847 6.56451 6.73769 -14.228 -11.1924 -15.3605 -431 2 14.2169 6.67596 6.68467 27.6084 8.49537 10.422 -432 2 13.086 6.40899 5.80997 -14.9004 -1.60425 -0.509451 -433 1 7.67719 2.38409 9.18276 -12.7481 -9.95901 -21.449 -434 2 7.23781 2.34079 10.0234 -2.84678 0.492631 19.9336 -435 2 6.97018 2.11077 8.55354 21.5545 6.86467 6.74712 -436 1 15.1528 14.8764 13.6487 -19.1236 6.62595 6.09279 -437 2 14.9964 15.042 14.5941 6.3649 -1.885 -8.0702 -438 2 14.3208 15.1168 13.2045 14.5757 -4.46306 2.19701 -439 1 9.29857 8.33432 3.70772 10.6355 -8.13532 4.49802 -440 2 10.1502 8.81328 3.76286 -8.0776 -10.0517 2.73632 -441 2 9.46492 7.39019 3.89736 0.427871 14.9166 -2.52044 -442 1 17.6858 13.4785 16.4504 18.1421 12.8824 -2.9019 -443 2 16.7336 13.3749 16.3876 -0.564153 6.32044 -4.53985 -444 2 17.9415 14.3223 16.0098 -13.7235 -15.3212 6.57805 -445 1 5.04165 10.6569 2.59879 15.0811 -13.5005 18.1704 -446 2 5.79991 10.2916 3.10884 -13.8602 3.81488 -12.1379 -447 2 4.57944 11.1735 3.25148 -7.64374 9.33605 4.93504 -448 1 3.71156 8.35988 10.3223 2.69392 -10.4458 7.32 -449 2 3.86762 9.29314 10.1995 2.90356 12.3134 -9.75827 -450 2 3.79851 8.25131 11.2818 -4.19061 -2.88345 -8.87222 -451 1 16.1009 7.11278 6.31821 6.57165 -19.5926 -13.3215 -452 2 16.7556 7.67982 6.75754 -3.32154 -9.30994 -6.24555 -453 2 16.5222 6.22545 6.20359 -10.7974 20.4957 5.39095 -454 1 15.1877 7.01217 9.11633 -0.942582 31.3193 -31.4924 -455 2 16.0087 7.4094 9.45282 -9.93766 -6.26011 -0.320925 -456 2 15.0368 7.51069 8.25256 3.47491 -21.9129 34.3614 -457 1 6.44498 13.1525 12.9077 -4.11711 1.46333 8.37594 -458 2 7.24124 12.6683 13.1519 -1.65948 -2.61146 -1.33868 -459 2 6.29723 13.796 13.6274 -0.63037 -8.66373 -16.4588 -460 1 12.122 4.49686 13.0678 27.186 16.1548 19.2119 -461 2 12.2551 4.61131 14.0219 7.12074 5.87928 -4.56992 -462 2 11.3374 3.99971 13.0395 -36.5276 -21.5475 -13.6693 -463 1 11.3413 8.18743 7.85231 -9.00357 4.77407 0.37365 -464 2 12.0188 7.6639 7.39095 2.25052 4.68793 14.2505 -465 2 11.6381 8.44006 8.74837 5.13859 -10.097 -12.5363 -466 1 17.1781 10.7776 7.41775 8.98079 -10.5429 4.93206 -467 2 17.827 10.053 7.20793 -14.7505 26.0455 -2.01259 -468 2 17.1485 11.4724 6.73654 6.61625 -12.2683 -1.04931 -469 1 5.23072 18.1435 11.0535 -19.1878 -10.0323 -1.26774 -470 2 4.70405 18.0783 11.8789 8.35901 -0.713622 -15.9457 -471 2 4.65273 17.8196 10.3204 13.2116 10.9899 16.482 -472 1 7.5638 17.6255 1.82385 0.18941 -4.57957 5.58349 -473 2 7.78527 16.8134 1.38126 5.66428 -18.4097 -0.230917 -474 2 7.45334 18.2192 1.09148 -1.66074 15.0057 -4.75644 -475 1 1.8616 12.9257 13.6096 9.14642 8.79388 9.51824 -476 2 1.6025 12.3584 14.3568 1.58601 7.25854 -8.04733 -477 2 2.19519 13.7677 13.9951 -8.21693 -20.1216 -3.01678 -478 1 9.73071 6.79429 14.803 -9.96431 20.7294 -5.24946 -479 2 9.965 5.93538 15.1079 4.49059 -29.2435 15.7374 -480 2 10.0131 6.81015 13.8895 1.7202 7.35701 -8.16934 -481 1 15.2073 4.3815 10.7753 5.02149 -7.87008 -1.3136 -482 2 16.102 4.07091 10.8622 12.544 -14.2164 -8.54624 -483 2 15.2461 5.11302 11.375 -14.5847 15.9831 9.57625 -484 1 11.1932 6.12384 0.161263 5.03411 2.82645 3.69768 -485 2 11.3288 5.17786 0.364595 -11.2178 11.9329 -9.49937 -486 2 10.2678 6.33084 18.566 9.25768 -12.2342 6.14633 -487 1 0.186838 11.3278 15.1363 -29.5173 30.1692 -23.1318 -488 2 18.3705 11.8565 14.4078 15.8912 -24.6881 20.4884 -489 2 18.5399 11.8236 15.9183 6.48048 -3.45982 -2.85079 -490 1 7.07004 9.14522 7.26474 -13.1186 -12.9635 8.90657 -491 2 6.53932 8.3872 7.60207 7.2147 19.6305 -8.47997 -492 2 7.95552 8.78183 7.22801 5.51641 0.721385 -0.901037 -493 1 18.4462 15.4465 12.3531 0.397712 -4.42488 4.01328 -494 2 0.764911 15.5581 12.2944 -10.8471 -1.16552 -3.91149 -495 2 18.1036 15.6779 11.4829 2.90793 1.2817 1.1609 -496 1 16.5729 4.36464 5.24677 -25.0478 -7.96005 29.4563 -497 2 16.6771 3.95228 6.15287 5.89012 16.1194 -31.2199 -498 2 17.3789 4.38374 4.73556 17.0857 -2.87844 2.77648 -499 1 17.7776 3.07164 10.7152 20.2072 1.91324 7.6701 -500 2 0.0768882 3.1314 10.9751 -16.1773 7.43675 -1.86825 -501 2 17.7244 2.20926 10.3009 -7.90603 -5.17093 -4.6179 -502 1 12.3097 0.0632784 10.17 -5.23585 14.9609 -0.662134 -503 2 11.3669 0.329281 10.3192 28.4735 0.874848 -0.34084 -504 2 12.8997 0.858518 10.2668 -24.0851 -21.9241 -3.33166 -505 1 10.3626 9.82488 12.3121 10.8795 10.4681 17.7395 -506 2 11.1241 9.87716 12.9295 -11.9387 -4.40292 -9.54779 -507 2 10.179 8.8911 12.2253 1.1465 -9.5921 -0.185536 -508 1 0.479623 2.83009 7.02164 2.3472 21.5918 -9.19818 -509 2 0.779466 3.61946 7.51564 -3.03286 -18.4976 -0.625243 -510 2 0.704445 2.06385 7.54355 5.66126 -3.27927 9.79357 -511 1 0.467007 15.244 6.91284 -2.81724 -38.2268 -9.44322 -512 2 0.589986 15.6097 7.78713 1.11258 -6.7374 10.833 -513 2 0.615386 14.2454 7.00377 -3.57496 47.8567 -6.78063 -514 1 16.9531 7.01102 15.3314 25.0955 -6.26352 -3.35293 -515 2 17.7312 7.54015 15.1398 -4.24099 15.1997 -5.49373 -516 2 17.3882 6.19624 15.5982 -13.584 -8.29127 -0.013797 -517 1 9.00968 12.4205 8.1448 -47.4595 3.97518 -14.6445 -518 2 9.255 11.8265 7.44329 24.3825 -11.7648 -7.05727 -519 2 8.04408 12.5071 7.93332 27.0995 7.32888 21.0703 -520 1 1.26609 1.94093 3.05591 2.05426 9.79258 -12.831 -521 2 1.21698 2.59367 2.33971 -7.6512 -12.9321 3.35408 -522 2 1.90984 2.32941 3.65026 1.81811 -2.05605 5.16186 -523 1 4.13335 15.1162 9.63732 -3.37236 0.94273 -0.929026 -524 2 4.11982 15.1465 8.67375 -6.81504 5.04573 1.04836 -525 2 4.9784 14.712 9.81623 8.98269 -4.0071 9.77097 -526 1 7.18021 2.17978 14.5671 7.55504 9.68183 9.47496 -527 2 6.93575 1.71258 13.7681 -0.50379 0.233559 -6.02908 -528 2 7.66352 2.97784 14.2972 -3.4628 -8.48803 0.116771 -529 1 18.6085 14.7119 2.15295 17.2538 -25.5542 -3.98016 -530 2 0.854482 15.0949 2.23403 -8.04084 1.8593 -0.311551 -531 2 17.9464 15.3611 2.33256 -11.9957 20.7574 3.41759 -532 1 9.94838 2.78838 12.9451 -1.38176 -12.4025 -13.9087 -533 2 9.76343 2.19068 12.1969 8.49761 3.03822 8.73498 -534 2 9.19943 3.38599 12.9407 -2.82035 8.06337 4.45668 -535 1 2.81023 8.91387 13.015 -11.0947 -9.09099 -1.03322 -536 2 3.12702 9.79437 12.8576 7.30933 17.7942 -2.89213 -537 2 3.52626 8.44288 13.432 10.5553 -8.83156 6.15268 -538 1 3.22981 8.35572 3.63929 7.91603 12.3414 59.3292 -539 2 3.55022 9.08279 3.12704 6.39159 12.4302 -19.4578 -540 2 3.47038 8.64809 4.58003 -14.7797 -20.4427 -37.089 -541 1 5.63158 7.19787 8.5111 -16.5836 -10.0318 8.45115 -542 2 5.49703 6.26423 8.32413 12.2862 -3.4998 -5.25722 -543 2 4.92977 7.35667 9.15199 5.58983 12.4707 2.72685 -544 1 14.8806 1.27947 2.01044 -5.20911 -29.6221 -13.7523 -545 2 14.8531 1.98102 2.64457 3.54145 24.2946 3.1913 -546 2 15.2413 1.51873 1.14568 -0.321243 12.6895 5.96264 -547 1 8.23741 15.1928 0.849855 10.5438 9.56485 -11.8122 -548 2 9.03414 15.1092 1.40038 -9.07879 -4.36113 3.60062 -549 2 7.50349 14.6875 1.21874 4.98636 -2.78068 7.26539 -550 1 15.6325 1.34538 7.23629 -19.2726 -10.6819 -7.69516 -551 2 14.9548 0.715658 6.87861 16.0521 20.279 9.35294 -552 2 15.1584 2.15623 7.4957 0.78871 -9.00488 -4.70177 -553 1 4.90948 13.0908 18.526 11.7484 -4.19917 14.2638 -554 2 5.32661 13.1046 0.771936 -5.81675 2.26251 -17.1314 -555 2 5.47193 13.6353 17.9612 2.08739 -3.03703 1.40027 -556 1 15.3444 8.47528 18.1477 10.5782 11.2904 -17.9652 -557 2 15.7712 9.10441 17.5134 -10.1785 -13.1115 16.9911 -558 2 15.2549 8.94211 0.342082 0.277618 5.95495 -1.45242 -559 1 12.072 3.0348 18.3713 9.16845 -16.043 3.97866 -560 2 11.9997 2.53228 0.532204 -11.5106 10.3924 18.501 -561 2 12.5782 2.36842 17.9104 5.62845 7.32417 -26.0863 -562 1 13.2089 12.6783 5.18015 6.63876 -6.29032 2.85699 -563 2 13.7391 11.9795 4.78379 -2.73226 -0.00342211 -8.22979 -564 2 13.3831 12.5487 6.11225 -3.40081 8.86391 8.40941 -565 1 6.04915 7.04527 0.0350485 10.8742 -21.2203 -4.52865 -566 2 6.02805 7.99092 18.6226 -5.46576 23.9499 6.727 -567 2 5.33859 6.76219 0.618839 -5.51003 3.35157 1.33709 -568 1 17.7393 16.0214 15.0094 13.9302 -13.9422 41.059 -569 2 16.9573 16.5339 15.2303 -2.65419 1.12677 -17.6965 -570 2 17.9199 15.9264 14.0844 -11.8828 6.17072 -25.9912 -571 1 13.1897 1.00209 16.5482 9.0285 -11.9403 8.82412 -572 2 14.1531 0.926941 16.6936 -12.5978 2.36886 -2.70952 -573 2 12.8801 0.0805392 16.5939 -0.793518 8.62378 -3.88342 -574 1 11.1147 14.5676 7.20714 13.0879 22.2032 -16.1382 -575 2 10.392 14.3041 7.74555 -20.7251 -13.6554 17.189 -576 2 11.8256 13.9392 7.33494 4.5733 -4.90634 5.95678 -577 1 17.5119 8.63301 2.08454 0.0660302 9.5119 10.6671 -578 2 16.6736 8.51459 2.527 -7.33525 3.37542 8.64387 -579 2 17.5132 7.89769 1.49414 7.23803 -17.2019 -20.825 -580 1 12.3543 7.99739 2.01665 -2.5776 9.38468 -13.8973 -581 2 12.1955 8.87571 1.62365 2.26325 -8.37679 12.9533 -582 2 11.9634 7.39841 1.37453 -1.21895 -7.08079 -1.91625 -583 1 11.8862 14.6191 10.3431 -20.5633 -33.2885 -21.2052 -584 2 12.048 13.7971 9.8109 4.18347 28.6601 18.3667 -585 2 10.9021 14.6739 10.3387 21.4811 7.86907 3.51893 -586 1 6.88785 7.04202 15.6064 18.5625 21.2571 16.3476 -587 2 7.79496 7.28653 15.325 -16.282 -10.9681 -3.58347 -588 2 6.76913 7.58838 16.4136 -4.66142 -14.4555 -17.927 -589 1 8.00173 4.72633 13.4744 30.8534 11.0647 12.2619 -590 2 7.23536 4.76996 12.9314 -21.7993 1.23146 -17.3356 -591 2 8.43981 5.59806 13.3773 -8.25054 -18.6352 3.63378 -592 1 13.408 12.1818 14.2607 -3.38159 -13.7589 -5.77775 -593 2 13.0599 11.273 14.209 4.17969 5.9499 4.9999 -594 2 13.8015 12.3234 13.3884 0.552928 6.09909 4.73433 -595 1 14.8332 9.42219 7.30259 -3.18701 -8.441 -7.55641 -596 2 15.6639 9.86655 7.42287 15.173 5.4083 -0.0492361 -597 2 14.1987 10.0431 7.62107 -17.8235 6.30723 6.71627 -598 1 12.6528 17.0596 3.07812 -8.70602 18.4808 5.33985 -599 2 12.9496 17.4673 3.92869 -9.46791 -7.74089 -22.4319 -600 2 12.0101 17.6853 2.63014 23.5323 -19.7514 22.4129 -601 1 1.16198 7.14088 17.4585 -7.06812 8.47411 -13.2553 -602 2 0.305081 7.19087 17.9183 5.00325 -4.47293 -7.14563 -603 2 1.04973 7.54449 16.5661 0.440843 -6.25707 18.2149 -604 1 12.7703 5.1502 15.6519 20.537 -9.206 9.03076 -605 2 13.4569 4.49661 15.9358 -13.2491 19.9411 -11.3493 -606 2 13.2029 6.02791 15.5919 -0.675517 -15.6076 2.74775 -607 1 2.52973 3.39372 4.98628 -12.5021 24.9114 40.8727 -608 2 1.78336 3.12225 5.60975 27.8197 11.256 -19.0698 -609 2 2.94772 4.23746 5.36491 -19.3389 -38.1774 -13.5008 -610 1 8.3189 11.2987 13.4496 33.0028 -42.3062 59.2485 -611 2 8.52043 10.9592 14.374 -32.1909 27.8732 -26.3694 -612 2 9.06111 10.8351 13.0577 -1.72326 7.29715 -30.1092 -613 1 12.8789 1.33643 13.3362 0.40834 22.0058 -3.21803 -614 2 13.4118 1.44301 12.5159 -13.2456 3.30889 14.5055 -615 2 12.3632 2.16071 13.5095 17.0122 -18.2145 -15.4576 -616 1 6.34323 13.7037 2.15004 -8.90275 3.4942 1.01633 -617 2 5.67068 13.9831 2.80896 17.8093 -8.54249 -8.97759 -618 2 6.94017 13.0667 2.55763 -1.44693 0.407866 6.84109 -619 1 15.9207 6.60938 12.7941 -14.0219 -16.6873 -1.46208 -620 2 16.3665 7.21966 12.2297 10.4548 13.0291 -14.3606 -621 2 16.4032 6.61209 13.6164 4.57404 0.312906 11.3916 -622 1 16.837 0.713429 9.59537 -4.60186 -23.2491 -5.40047 -623 2 16.7766 18.3812 9.76009 1.861 23.059 -1.51736 -624 2 16.4539 0.846132 8.70764 2.52408 0.807103 8.64662 -625 1 6.14677 11.7538 8.37929 1.46343 -38.2042 -1.58984 -626 2 5.28119 11.5099 8.79312 19.6536 2.3972 -11.55 -627 2 6.62627 10.8955 8.13754 -23.51 30.7545 10.2414 -628 1 2.89887 8.61954 0.44521 -58.0253 1.44029 -30.8084 -629 2 2.28026 8.19904 18.4406 35.2092 -5.33136 7.34884 -630 2 2.23436 9.22701 0.790296 19.604 11.6332 17.9417 -631 1 10.1646 10.4607 6.5042 -2.67562 1.82661 -6.4385 -632 2 10.6119 9.73033 6.95167 0.990091 1.19991 -1.59039 -633 2 10.4858 10.4732 5.58284 -1.09389 -1.85789 13.424 -634 1 6.73063 15.6946 6.55447 -0.851851 -4.83477 5.20485 -635 2 7.09829 16.1491 7.32752 1.36873 0.436433 -10.1699 -636 2 7.02842 16.1335 5.74515 1.47904 6.69628 7.42626 -637 1 6.44804 13.1708 5.58287 -3.43311 -13.1021 10.8705 -638 2 6.66139 13.9646 6.07673 2.2473 5.97996 0.728386 -639 2 6.06157 12.5687 6.2363 0.868112 2.44944 -5.20285 -640 1 16.8203 12.5595 9.83963 -1.29973 -13.3798 -26.0882 -641 2 16.9797 11.9255 9.1094 -0.187484 2.38257 16.1818 -642 2 16.6351 13.3676 9.36293 0.809528 9.54538 5.72824 -643 1 6.04152 2.95052 2.84999 -1.13024 -25.4835 15.2707 -644 2 6.4006 3.79327 2.62573 5.01416 22.8678 -12.9444 -645 2 5.58314 2.5656 2.09763 0.434854 2.67004 -8.58918 -646 1 10.9107 3.32852 3.29939 -12.4238 -2.51051 -2.149 -647 2 10.2568 3.99067 3.55961 5.98057 0.0707186 3.553 -648 2 10.4887 2.88551 2.55708 3.841 -3.98893 -4.96007 -ITEM: TIMESTEP -20 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.69334 7.07477 17.9589 0.0661907 -8.15672 -5.93801 -2 2 7.76544 6.892 18.1438 2.06168 0.344835 4.67083 -3 2 8.87494 6.58302 17.1494 0.0923072 2.18051 2.08263 -4 1 18.5724 8.27759 6.8487 9.68108 -9.0135 5.9796 -5 2 0.0748736 7.96696 5.95521 0.0469709 2.78304 -15.7461 -6 2 0.399795 7.62446 7.38749 -2.21574 6.41883 6.02377 -7 1 8.4 18.5641 6.8134 3.87483 8.82198 -0.0595031 -8 2 9.32611 0.166963 6.70047 -3.24105 -1.28376 -0.166563 -9 2 7.89494 0.641414 6.41149 2.5055 -2.76566 0.153015 -10 1 6.59225 1.83896 11.6912 -0.275689 0.302437 5.80014 -11 2 5.92509 2.27303 12.2308 -4.07131 5.9643 -4.10931 -12 2 6.1821 1.00166 11.4658 -1.55571 -7.95905 -4.17259 -13 1 7.1255 5.73378 2.34451 -23.1841 27.0209 10.5427 -14 2 6.64356 6.29382 2.99422 10.5833 -21.9235 -2.45439 -15 2 6.93596 6.23963 1.54379 8.61204 -12.4491 -6.79559 -16 1 16.2118 10.162 16.1238 9.73263 11.3036 -6.58381 -17 2 17.0956 10.2901 15.7587 -2.05967 -6.96031 3.12171 -18 2 15.9212 11.066 16.279 -7.86411 -1.51367 3.55804 -19 1 10.6155 15.0016 2.3147 2.6864 2.11515 1.56294 -20 2 10.6002 14.5314 3.15674 -2.41534 -3.03603 0.679536 -21 2 11.0785 15.8209 2.51731 -0.0195897 0.981381 0.0978469 -22 1 17.1585 8.25197 10.4305 1.44624 0.93325 5.78222 -23 2 16.6499 8.94547 10.8694 -0.557047 -3.86734 3.9084 -24 2 18.0092 8.65295 10.2197 -0.225121 0.250414 -1.13708 -25 1 14.8741 15.8852 16.3481 -7.08493 -6.82471 0.413246 -26 2 13.9679 16.1979 16.3007 -7.09092 5.8218 -2.34027 -27 2 14.8494 15.2418 17.0641 6.82868 3.48864 5.90805 -28 1 12.1588 13.3817 0.433178 -6.27467 12.7595 -4.80914 -29 2 12.0352 13.6324 18.1551 4.79076 -7.76922 -3.88045 -30 2 11.6846 14.0735 0.910169 -3.08866 -6.36125 10.7585 -31 1 9.27449 5.40778 4.04397 -13.9365 -16.0184 3.55858 -32 2 8.80012 5.02015 4.81047 7.30704 13.9384 -9.37026 -33 2 8.62496 5.33174 3.3181 9.32114 8.483 4.67507 -34 1 1.82732 4.26294 11.6464 -4.04254 -2.69427 0.93532 -35 2 1.77693 5.20244 11.8864 -0.000737327 -7.07977 -0.141665 -36 2 2.24287 3.78422 12.3753 -0.858945 2.71416 -2.4423 -37 1 1.98268 6.82933 8.36887 -4.76513 2.22844 -15.7156 -38 2 2.36253 7.23451 9.15103 4.34961 -4.46197 5.21996 -39 2 2.01952 5.87123 8.47722 1.07428 0.125821 9.68028 -40 1 5.39566 4.39684 7.93565 8.0799 8.40992 8.79829 -41 2 5.46014 3.43633 8.01893 -3.87159 0.552259 -10.4859 -42 2 4.76986 4.63893 7.2446 -2.8004 -4.28351 -0.196723 -43 1 3.26324 2.92599 17.538 -6.48526 11.4036 5.90093 -44 2 3.9521 3.41084 17.0519 -4.33162 -2.5567 2.49087 -45 2 2.74469 3.58038 18.0606 14.1441 -6.64194 -12.4081 -46 1 7.47828 5.27232 6.10849 -6.04695 1.38866 -9.34596 -47 2 7.88111 5.94624 6.68322 -4.96979 -11.9122 3.47667 -48 2 6.82246 4.73008 6.58045 9.57964 11.031 7.72945 -49 1 9.77144 7.02208 11.9904 4.73189 -1.1383 -1.06285 -50 2 10.3467 6.38126 11.5734 3.30689 -2.46386 0.831607 -51 2 9.14216 7.24941 11.3005 -7.52384 3.80108 0.31383 -52 1 14.0798 3.55416 8.05513 -3.28328 4.35009 -1.93857 -53 2 13.7004 4.26501 7.52877 0.673114 -0.544944 -0.0617854 -54 2 14.5392 3.99696 8.77439 -0.252332 -0.945414 2.55344 -55 1 4.73763 17.2389 4.01031 -0.321378 8.61877 -17.0141 -56 2 5.59566 17.6635 4.11691 -0.835388 -5.76098 7.55997 -57 2 4.38449 17.6475 3.19969 -7.45685 -7.93836 11.3283 -58 1 16.5107 16.6056 10.0759 6.54448 8.81329 9.76337 -59 2 15.9397 16.7408 10.8388 -5.01232 -5.78767 -1.53078 -60 2 15.9723 16.2069 9.3894 -4.78788 -4.31379 0.495659 -61 1 1.96746 4.90416 0.450775 -1.81832 7.5424 0.20662 -62 2 2.57813 5.33173 1.07474 -1.76589 -7.7088 -3.71938 -63 2 1.58349 5.65244 18.6136 5.80255 -6.17515 -0.843526 -64 1 11.7761 13.343 16.2841 -6.04701 8.80367 11.8739 -65 2 11.2992 12.5177 16.4849 4.5736 1.77316 -11.3497 -66 2 12.2862 13.2596 15.4658 -7.12668 -12.5479 1.29578 -67 1 10.1128 11.0591 16.9331 1.69597 -16.074 1.546 -68 2 10.529 10.1874 17.0807 -3.30995 11.3925 -3.21813 -69 2 9.18388 10.849 16.7697 3.68635 3.27029 -1.84825 -70 1 11.7127 17.5197 13.4648 11.3019 2.11475 -5.22831 -71 2 12.331 17.0869 12.8651 -0.203424 -4.77186 2.96515 -72 2 11.9976 18.4453 13.422 -5.71015 -0.897636 4.76739 -73 1 6.35333 9.30557 12.2266 11.9787 8.60001 -4.91149 -74 2 6.91868 9.08658 11.4768 -7.06745 -10.6307 -2.02859 -75 2 6.87303 9.9972 12.642 -2.68502 3.03115 9.09234 -76 1 16.2229 12.7446 2.69624 -0.291567 -17.1772 2.14859 -77 2 17.0444 13.127 2.38556 1.82795 9.93981 0.639945 -78 2 15.5737 13.4355 2.84522 -0.398116 10.9003 -3.52894 -79 1 0.630414 12.571 5.87324 -2.78001 5.23525 -2.09291 -80 2 1.00794 12.4159 4.99822 -5.49855 2.79722 0.151968 -81 2 18.3568 12.8603 5.70082 10.405 -7.04854 2.54099 -82 1 5.20787 16.4001 18.4776 -12.5497 0.602195 -7.10426 -83 2 5.86464 15.8156 18.076 4.18722 4.70251 6.39081 -84 2 5.5918 16.9091 0.552483 9.38889 -4.76533 -0.723228 -85 1 0.52849 7.63403 4.08589 29.1287 17.8407 -12.6947 -86 2 18.5836 7.90722 3.36083 3.6478 2.13346 8.06342 -87 2 1.42012 8.03877 3.86645 -30.4536 -16.431 6.17599 -88 1 3.1381 8.91119 6.51072 -13.5755 -1.26875 13.9192 -89 2 3.59199 8.61596 7.312 -0.196935 0.713487 -8.34602 -90 2 2.19086 8.84537 6.73861 12.9731 1.00292 -6.41375 -91 1 7.31254 10.3111 16.1924 3.71601 3.69021 9.41051 -92 2 6.5835 10.5117 15.6001 -2.45726 -1.05124 6.16708 -93 2 6.97924 10.3433 17.1122 -4.5268 -1.10556 -13.1914 -94 1 11.1003 1.05051 4.99797 5.80988 -5.62906 14.1745 -95 2 11.3837 1.86623 4.56736 -9.38615 -1.44268 -8.87945 -96 2 10.7526 0.427875 4.34338 1.37635 7.2616 -4.61902 -97 1 4.41216 2.72626 13.196 4.39031 -15.812 27.2385 -98 2 4.68873 3.14242 14.0209 1.29771 13.5884 -6.24163 -99 2 4.35373 1.80262 13.5146 -5.93981 4.62314 -19.463 -100 1 8.39633 10.0477 1.8021 8.65231 5.58991 3.9521 -101 2 8.43584 10.7505 2.47552 -3.18527 -5.8592 -1.95349 -102 2 8.78245 9.25294 2.20632 -6.17245 6.11296 -0.869653 -103 1 10.5167 1.74791 15.5607 -12.987 -0.969766 6.95693 -104 2 11.4294 1.4693 15.6846 2.64548 4.13814 -6.20872 -105 2 10.3497 1.97094 14.6365 5.88046 -1.13362 -2.56443 -106 1 2.75172 12.9341 7.77038 -1.98364 -2.25212 -7.11701 -107 2 3.34024 13.5411 7.30753 1.72417 1.81116 5.40918 -108 2 2.20386 12.578 7.06153 -5.53374 1.90184 4.06344 -109 1 3.65904 11.6762 5.27167 1.4745 3.00351 -5.43274 -110 2 3.4246 11.0613 5.97769 -1.9036 -0.651658 -6.95213 -111 2 2.87422 11.8691 4.73548 4.37313 -4.77202 2.40024 -112 1 6.8497 14.4837 16.8623 -7.20011 -2.9268 7.54224 -113 2 7.64382 13.9472 16.8068 -1.68272 1.48794 -3.62778 -114 2 6.45279 14.5388 15.9848 5.36951 2.03983 -1.60361 -115 1 14.1732 14.5515 3.40534 8.00808 -4.71428 -5.83886 -116 2 13.686 15.3662 3.26714 -6.11485 0.946493 -0.0166146 -117 2 13.6673 13.9759 3.98664 -1.2314 3.40033 5.39954 -118 1 8.29912 18.1674 16.0589 -20.5282 -4.34905 -0.197762 -119 2 8.7408 17.3576 16.3653 13.9085 14.9544 -3.06277 -120 2 8.83266 0.312858 15.8727 12.6636 -13.3116 3.05514 -121 1 4.73053 1.62244 4.91728 3.73461 17.8941 -9.82498 -122 2 3.87083 2.07692 4.90413 8.70323 -5.84393 3.64668 -123 2 5.31846 2.19299 4.38363 -11.3635 -9.88313 3.69576 -124 1 15.0998 12.7921 16.4359 -16.5392 5.6559 5.83964 -125 2 14.613 13.1569 17.1797 9.93151 -3.40376 10.0434 -126 2 14.4182 12.7815 15.762 4.3611 -9.31248 -14.0367 -127 1 15.7898 18.3971 16.8042 5.79346 -1.22695 27.8179 -128 2 16.3329 18.5498 17.6117 -9.65553 4.21222 -20.1346 -129 2 15.4648 17.4968 16.9407 3.00983 3.14177 -9.23088 -130 1 1.14588 1.15091 16.5513 6.84042 -4.63386 -6.55399 -131 2 1.94328 1.67743 16.706 -5.62204 0.173811 5.06431 -132 2 0.528577 1.37004 17.2554 5.0728 5.5861 0.922174 -133 1 18.0913 4.5707 15.884 4.25376 -5.47852 -1.15194 -134 2 18.5654 4.01411 15.2573 -2.45188 0.25544 1.09753 -135 2 18.6545 4.64521 16.6589 -1.38654 0.113736 -2.45626 -136 1 12.2253 16.9711 16.1412 0.914186 -11.4555 3.91466 -137 2 11.5632 16.3741 16.5429 5.70701 14.4982 -7.43821 -138 2 12.0767 16.9746 15.1851 -6.52552 1.11271 2.73005 -139 1 15.9091 2.53324 17.9911 -0.813861 17.5084 -1.21546 -140 2 15.6764 3.36649 18.4268 1.17892 -6.2644 3.50604 -141 2 15.6868 2.72575 17.0644 4.5424 -10.5093 4.50867 -142 1 6.70264 13.8034 10.241 3.67042 13.5267 -3.47207 -143 2 6.65382 13.63 11.1889 -2.71481 -10.4168 -1.32753 -144 2 6.64075 12.981 9.74212 -1.13183 -3.39045 4.84834 -145 1 10.1303 18.2368 2.79334 3.88934 4.25391 -9.05815 -146 2 10.3528 0.228802 2.09034 -3.74927 -2.61302 6.3793 -147 2 9.24556 17.9143 2.58077 2.23777 4.46644 1.38681 -148 1 2.97822 17.7592 6.09436 6.84514 -11.0569 -16.6755 -149 2 2.2147 17.6257 5.53291 -18.2595 3.26089 9.16469 -150 2 3.66284 17.6557 5.427 11.9633 8.77303 4.67614 -151 1 12.5626 16.9639 7.98676 12.5848 -1.11028 -8.52053 -152 2 11.8839 16.2724 7.94525 -2.9484 9.81966 4.92503 -153 2 12.3706 17.6612 8.63222 -7.85492 -11.7975 4.91014 -154 1 14.885 15.2749 8.26678 1.09184 -13.1129 19.8008 -155 2 14.1202 15.8628 8.27106 1.10724 6.83397 -10.769 -156 2 15.4286 15.3633 7.48102 -5.52588 8.50153 -14.3957 -157 1 17.5862 18.2834 0.376986 -24.9344 -1.23553 -1.17468 -158 2 18.3469 17.8479 0.005767 18.8411 -2.89863 0.907383 -159 2 17.8259 0.448151 0.831731 10.0339 0.947456 -0.506579 -160 1 0.885899 10.3809 1.40397 7.22911 -11.5028 6.53987 -161 2 0.114071 9.81378 1.55479 0.851643 9.57639 -0.353744 -162 2 0.635753 11.1007 0.824785 -9.84019 7.34982 -5.0696 -163 1 1.59112 12.2023 3.3355 8.42913 -7.93475 21.5428 -164 2 1.38243 11.4488 2.766 -0.926106 10.11 -6.99043 -165 2 1.6499 13.0233 2.84482 -2.64968 -0.879455 -11.853 -166 1 0.551086 17.2511 4.8776 21.276 -3.63263 -24.3978 -167 2 -0.0762795 17.9651 4.97462 -6.3407 4.63135 13.3725 -168 2 0.558623 16.612 5.58807 -10.7338 -2.48853 14.1039 -169 1 1.11389 0.976548 9.40441 -9.70348 2.26791 0.52143 -170 2 1.20067 0.739298 10.3296 11.5619 -5.66825 6.05541 -171 2 0.194683 0.747268 9.24308 -0.993818 -3.51563 -8.196 -172 1 16.7801 2.33697 13.2827 1.26658 -2.58515 -3.42214 -173 2 16.9917 2.52603 12.3542 -2.2694 -1.44301 7.47438 -174 2 16.5315 1.40163 13.3451 -1.6586 3.84983 -3.29893 -175 1 2.50653 15.8317 12.198 6.9942 0.0378495 -5.39106 -176 2 3.03319 15.4932 12.933 -2.33393 0.151651 -5.20129 -177 2 2.92041 15.5438 11.3652 -1.63849 1.19534 6.62391 -178 1 16.4211 15.5676 5.95733 20.9565 28.2944 1.83954 -179 2 17.3426 15.5843 6.27645 -8.81355 -7.9692 1.26231 -180 2 16.3612 16.4166 5.46885 -9.28613 -17.0928 2.60564 -181 1 5.82453 5.03389 11.7824 5.33446 0.320875 1.57619 -182 2 5.57998 5.74431 12.3877 -7.39983 3.16893 -2.12011 -183 2 5.27405 4.27426 12.0034 -1.54313 1.61628 -0.196815 -184 1 15.2115 4.85871 0.718957 -12.3292 -1.21553 20.1953 -185 2 14.9951 4.64926 1.65891 1.99725 2.35951 -19.8125 -186 2 14.3839 5.18637 18.9796 8.05664 -2.8997 2.32554 -187 1 16.3489 16.3233 2.11444 -1.37403 -13.232 -8.15517 -188 2 15.9103 16.7203 2.87049 4.10511 7.42013 3.0617 -189 2 16.5474 17.0218 1.48672 0.743353 6.63736 2.3016 -190 1 0.282027 4.87119 3.80055 19.2835 17.3487 3.53091 -191 2 0.489613 5.83173 3.76503 -11.8967 -17.4303 3.14809 -192 2 1.11089 4.48306 4.11838 -9.18259 -2.61174 -2.176 -193 1 2.9303 15.0125 15.0392 0.0573492 -0.181072 31.7668 -194 2 2.82615 14.584 15.9186 6.41531 2.15453 -14.4377 -195 2 2.5906 15.8967 15.228 -6.81336 0.182398 -11.4579 -196 1 1.12223 14.6049 9.5632 13.1187 -18.7351 -0.898815 -197 2 1.97867 14.3698 9.19328 2.71847 14.7063 -6.21023 -198 2 0.940175 13.7592 9.98602 -14.9991 7.00648 6.43026 -199 1 13.665 16.6454 11.5316 -21.8339 3.0331 3.55613 -200 2 13.1746 17.4327 11.223 10.4467 -7.06131 -5.36321 -201 2 13.1002 15.9021 11.2581 8.49503 1.30575 -4.9094 -202 1 4.71709 1.47693 0.719081 -0.792104 -2.26487 7.67979 -203 2 4.13723 2.08795 0.242023 0.0358417 -6.61504 -0.0652634 -204 2 4.16248 0.903426 1.27536 -1.89276 3.42768 -9.42283 -205 1 1.43372 18.4947 11.8904 0.435024 0.903574 -5.06079 -206 2 1.25876 0.369488 12.6813 0.171373 0.403899 4.07674 -207 2 1.76959 17.6363 12.1756 0.0129122 3.12302 0.145238 -208 1 11.5344 10.1145 4.09755 11.0508 4.0163 -22.2825 -209 2 11.4066 10.5292 3.21014 2.38528 -6.34716 18.1192 -210 2 12.5036 10.0411 4.22804 -15.2135 3.993 -1.98571 -211 1 8.36281 12.1777 3.74701 -13.1943 -6.81146 -12.1909 -212 2 9.18722 12.6378 3.9579 -8.09176 1.3179 12.2751 -213 2 7.70079 12.2682 4.46238 18.0882 5.10492 -3.45512 -214 1 14.3344 4.02288 3.28855 15.2498 3.93213 6.6836 -215 2 15.0617 4.23514 3.91062 -12.0049 -4.72392 -3.76747 -216 2 13.5379 4.47251 3.60621 4.75183 0.0120405 -3.02562 -217 1 5.58434 1.74596 7.50985 -22.3692 -26.8297 9.12948 -218 2 4.91823 1.11394 7.92632 27.2868 23.8434 -15.8784 -219 2 5.43743 1.67946 6.54893 -3.28939 1.24453 9.56906 -220 1 17.9012 1.11073 4.88195 -3.31078 -7.47428 -4.80941 -221 2 18.5525 1.45486 4.25184 -3.70144 3.91348 6.86656 -222 2 17.7599 1.74881 5.59037 4.24211 2.13046 -3.7457 -223 1 6.8304 9.4053 4.48372 -13.6803 0.789023 -7.06041 -224 2 6.74666 9.48009 5.43928 9.48337 1.88908 4.46236 -225 2 7.74899 9.21301 4.27057 2.55497 -2.6247 5.048 -226 1 2.68932 14.9418 1.9668 -6.12139 1.43036 2.89635 -227 2 3.30587 14.7185 2.6759 1.77318 0.618157 -6.66396 -228 2 3.15681 14.9246 1.12432 2.70839 -4.47578 5.21755 -229 1 17.2859 12.889 13.1454 -5.46423 18.1991 -4.92566 -230 2 16.4361 13.3067 13.278 -15.9577 -14.9195 9.16742 -231 2 17.7285 13.6846 12.8505 24.3586 -1.49654 -2.29875 -232 1 15.0069 10.5712 1.38624 -2.11062 -3.1818 -0.491761 -233 2 15.5786 11.255 1.74854 2.03128 0.359313 2.4477 -234 2 14.2323 11.0405 1.08579 -5.34855 2.20107 -0.889893 -235 1 5.70672 6.90314 4.53443 4.24519 -5.28557 8.89432 -236 2 5.96576 7.83558 4.52332 0.860976 -3.32444 -1.54743 -237 2 6.34045 6.45199 5.11743 -0.773999 0.740319 -5.54545 -238 1 8.07933 8.28074 10.2171 -3.64639 -3.67369 23.1077 -239 2 8.76707 8.87858 9.90894 -2.7343 3.77639 -10.7375 -240 2 7.6749 7.81667 9.48055 2.86655 5.40525 -7.79011 -241 1 13.5084 18.3075 5.79227 -0.609935 12.5659 -0.945985 -242 2 12.8781 0.387145 5.63591 -2.7451 -9.905 0.332396 -243 2 13.1846 17.8335 6.57076 -1.7745 -1.29433 -5.46225 -244 1 0.277736 2.58212 0.118598 0.621477 -2.00702 8.56184 -245 2 17.957 2.7127 18.6839 10.2871 11.0559 -0.501636 -246 2 0.794319 3.38844 0.33639 -19.4232 -4.52538 -3.88061 -247 1 12.6801 10.9983 9.7602 -12.9965 -11.6862 -0.561246 -248 2 11.7228 10.8953 9.6485 6.19444 12.5166 -3.56604 -249 2 12.897 10.0826 9.9647 14.0656 0.707903 4.64438 -250 1 0.781933 12.2574 11.0872 -6.04901 -2.18816 6.07288 -251 2 18.4712 12.3682 11.1342 -4.62852 -2.97634 -7.25325 -252 2 1.06266 12.4852 11.9795 7.76729 1.60409 -2.26455 -253 1 5.05561 7.24886 13.466 -11.4852 -6.03635 -4.86876 -254 2 5.50236 8.03712 13.1394 10.7241 -0.576345 -1.34855 -255 2 5.49314 6.97472 14.2774 5.89817 7.37955 3.96262 -256 1 1.26581 6.94402 11.8396 4.62667 -0.613543 7.50244 -257 2 0.504801 7.20295 11.3208 -2.84364 2.86798 -1.49635 -258 2 1.66495 7.76854 12.1529 -2.34869 -3.61795 -5.23307 -259 1 15.4733 9.48228 12.3076 -4.70583 25.6475 16.0975 -260 2 15.3149 10.4406 12.4106 2.52372 -12.0579 -11.0564 -261 2 15.3983 9.16189 13.2139 2.67764 -6.7615 -6.72177 -262 1 16.6336 12.9201 5.4628 6.66579 -20.8603 16.0577 -263 2 16.5173 13.872 5.54201 -7.55482 0.841067 -13.5204 -264 2 16.4587 12.5944 4.56908 -1.3904 13.4091 -1.6671 -265 1 6.18458 10.0203 0.145227 10.7922 -3.52818 2.39688 -266 2 5.51531 10.431 0.700604 -4.05423 0.759005 -2.7608 -267 2 6.99302 10.1148 0.667984 -1.67417 -4.19008 -1.28624 -268 1 12.3589 6.06668 4.038 0.452115 -1.15559 12.336 -269 2 12.2616 6.902 3.56852 -2.7325 -0.676505 -9.18667 -270 2 11.4806 5.67315 4.10483 0.607886 2.8799 -4.57435 -271 1 0.151536 12.8218 0.203335 4.13456 -2.94622 -2.33064 -272 2 -0.0129983 13.5003 0.871422 4.06521 1.52419 -2.90371 -273 2 18.34 13.1254 18.0507 -1.07008 -0.669132 2.22617 -274 1 3.8124 18.585 8.59267 3.71655 -0.510361 5.11861 -275 2 3.56708 18.0759 7.80793 -6.58546 5.02297 1.51156 -276 2 3.01311 0.371537 8.92178 -4.29721 -3.94788 -5.16471 -277 1 7.41673 17.2735 4.46563 5.27699 16.8729 -12.8498 -278 2 7.96434 18.0381 4.66458 -2.5447 -1.66977 13.1327 -279 2 7.34622 17.3735 3.5102 -3.86431 -11.0257 -0.167405 -280 1 9.22722 17.0589 12.2393 19.2623 -14.5641 0.108859 -281 2 9.27149 16.2912 11.647 -4.87121 6.1965 2.03703 -282 2 10.0709 17.0037 12.729 -13.5572 10.6592 -2.64279 -283 1 13.3059 12.9585 7.95053 -5.93488 5.61094 -2.56551 -284 2 13.3162 12.2379 8.59837 1.79032 5.44422 0.740585 -285 2 13.8923 13.6822 8.21069 6.53108 -7.176 5.15054 -286 1 14.9676 2.9565 15.3436 -0.386658 0.574387 3.68052 -287 2 14.4202 2.18777 15.1252 1.77471 7.19316 -4.43588 -288 2 15.6633 3.03092 14.6718 -7.27619 -4.52831 0.823712 -289 1 9.86266 15.5244 17.0043 3.51131 -4.56125 -2.22878 -290 2 10.4016 14.759 16.7592 -3.4195 -0.793849 -1.98877 -291 2 9.23782 15.2217 17.674 1.65588 4.18023 5.21634 -292 1 11.2982 8.26605 16.5436 5.00814 15.3472 3.18516 -293 2 10.6561 7.79454 16.0057 0.999826 -4.04983 -0.0472571 -294 2 11.6606 7.65108 17.1873 -4.09078 -4.29715 -0.00155616 -295 1 3.81225 18.1964 16.7292 10.4788 2.16731 8.30533 -296 2 4.28955 17.5863 17.3008 -0.586781 -10.0924 -3.62086 -297 2 3.8829 0.368785 17.226 -6.17555 6.78007 -4.03101 -298 1 2.19803 4.12169 8.95254 -8.42555 5.0907 -8.8117 -299 2 3.07539 3.82533 8.67919 -2.6088 -0.1453 11.8715 -300 2 2.06404 4.00225 9.90658 13.5851 0.597917 -5.47855 -301 1 9.88178 10.3569 9.73038 4.79618 9.75255 -1.56513 -302 2 9.58096 11.2105 9.34815 0.270313 -13.7408 11.2463 -303 2 10.0884 10.4563 10.6769 -5.68787 3.60286 -6.41077 -304 1 9.72212 0.809424 10.8539 19.6856 13.2875 8.50656 -305 2 9.35568 18.6419 11.2241 -8.56647 -0.801274 -6.22283 -306 2 9.1718 1.19131 10.1642 -10.1616 -7.34852 -1.36201 -307 1 9.20808 15.1775 10.2123 -15.4381 -3.13199 6.73164 -308 2 8.85567 15.9769 9.80113 1.42232 -2.21967 -3.83769 -309 2 8.41617 14.6283 10.3808 11.8702 3.92611 -8.2586 -310 1 0.995689 9.3369 10.3259 -16.0333 -0.722577 -1.64132 -311 2 1.04111 10.3025 10.3672 11.5337 -2.90556 1.12718 -312 2 1.85551 8.94205 10.1494 2.50931 13.4523 1.23502 -313 1 16.8622 4.87275 8.19393 -0.422934 0.254968 7.2846 -314 2 16.1689 5.44633 8.57547 10.3862 -6.79292 -0.962882 -315 2 17.2033 4.29721 8.90095 -5.62498 7.92604 -8.45296 -316 1 14.656 14.7011 0.368319 0.981504 1.6367 -2.03469 -317 2 15.1464 15.0731 1.12238 -4.61865 -0.709772 -8.09446 -318 2 13.8079 14.3976 0.718239 6.88081 -1.79732 0.157513 -319 1 3.54139 11.054 9.61635 4.40574 2.25524 -6.23941 -320 2 3.65641 11.5568 10.4349 -3.33961 -4.79202 -0.629126 -321 2 3.06202 11.6341 9.00365 5.95536 0.511998 4.3162 -322 1 11.0657 10.8474 1.29636 2.92174 -3.12366 4.90686 -323 2 11.2982 11.6263 0.767958 -3.5102 -3.65436 5.75862 -324 2 10.1232 10.6698 1.15822 5.54645 2.63321 -1.67034 -325 1 13.2072 7.07995 12.8701 -0.715054 4.17079 -6.48984 -326 2 14.1512 6.89692 12.9697 -2.29399 1.70307 -2.36257 -327 2 12.7789 6.22148 12.7926 -0.519741 -2.64677 3.01569 -328 1 9.62848 1.89714 0.960589 0.144249 -1.27383 8.14422 -329 2 8.75389 1.7191 0.595255 2.62606 0.878667 -4.42234 -330 2 10.2646 1.96201 0.242782 -4.84565 1.17493 -5.89222 -331 1 10.5889 13.5223 4.7138 2.80012 2.67941 -15.7349 -332 2 11.4734 13.1444 4.59356 -4.0194 -1.02806 11.2737 -333 2 10.6142 14.0248 5.53615 3.92037 -3.05166 -0.671 -334 1 14.2891 1.71547 10.914 14.736 9.54636 -9.28817 -335 2 15.0906 1.40219 10.4788 -2.27816 -10.6125 3.67971 -336 2 14.438 2.66833 10.8812 -8.3278 1.7804 6.62982 -337 1 14.6539 12.3888 11.7057 -9.85382 -5.79197 9.84531 -338 2 15.5174 12.4906 11.2689 -13.4179 -5.72309 -9.10321 -339 2 13.9464 12.0325 11.1297 19.1264 4.07718 -1.67851 -340 1 8.24463 5.07042 9.80489 8.67652 16.3821 0.210642 -341 2 7.41075 5.25266 10.2586 0.116202 -10.888 -2.54867 -342 2 8.19641 4.23298 9.33202 -10.3006 -5.74151 5.58561 -343 1 1.57762 16.8331 18.335 1.68687 -2.26048 -0.033424 -344 2 1.80587 17.1847 17.4697 -0.252498 3.71983 1.68741 -345 2 2.01633 15.9753 18.3429 -7.29056 -3.61139 0.997127 -346 1 1.4432 17.2346 15.332 2.65894 -7.35401 -5.7102 -347 2 1.56202 18.0921 15.7447 -7.04866 6.37518 1.22888 -348 2 0.495246 17.0477 15.225 10.7628 4.03376 7.259 -349 1 3.71499 5.60328 6.17396 -2.46237 18.0728 1.59518 -350 2 3.14409 6.20568 6.67532 2.19379 -7.75625 0.984178 -351 2 4.32024 6.21155 5.72591 -1.08806 -7.05296 -5.84211 -352 1 12.3532 9.43776 14.1893 13.0079 -11.8089 -5.25996 -353 2 12.7562 8.63341 13.7793 -8.52026 15.4152 14.9752 -354 2 12.1872 9.21442 15.1219 0.0848175 -4.0166 -10.4276 -355 1 4.03165 15.279 6.91423 11.4052 5.55751 -7.84178 -356 2 3.54353 15.996 6.48767 -3.99323 -1.71496 7.04649 -357 2 4.96733 15.4866 6.74143 -6.91754 -4.3684 4.91577 -358 1 0.598678 8.56195 14.8837 5.20406 11.6905 0.774862 -359 2 0.593362 9.51845 15.0326 -4.59172 -3.85379 3.33684 -360 2 1.20863 8.47913 14.1435 0.530109 -4.80423 2.60663 -361 1 12.9822 8.33824 10.332 -12.7812 8.13505 -15.7365 -362 2 13.7449 7.91273 9.91994 1.65618 -4.07378 8.99333 -363 2 12.9305 8.07685 11.2552 9.52621 -6.7264 2.9301 -364 1 15.3077 7.66451 3.49902 -16.235 -26.2008 20.478 -365 2 14.5457 7.14577 3.24297 -4.72624 11.0142 -23.2354 -366 2 15.4625 7.21195 4.33822 21.3334 18.0327 3.91528 -367 1 17.3129 6.65992 0.0418436 1.52354 1.06354 -1.27952 -368 2 16.9014 5.84978 0.373955 -3.48337 6.90323 -1.87832 -369 2 16.58 7.23266 18.3971 4.62858 -6.17573 2.16922 -370 1 8.83009 6.92284 7.82744 0.252992 -5.92817 5.57761 -371 2 9.76137 7.15634 7.81451 4.22584 7.3373 -3.58966 -372 2 8.73794 6.33872 8.59756 -2.97854 -0.622916 -4.66555 -373 1 12.3396 0.625886 1.18148 -8.16379 -0.652746 9.01197 -374 2 13.1345 0.755236 1.71568 4.24005 -1.61972 -8.33969 -375 2 12.5055 18.5332 0.58867 3.80642 2.13695 -0.293066 -376 1 5.66619 15.1148 14.5143 -6.5884 11.0519 3.391 -377 2 4.74474 15.2404 14.7783 -0.0534379 -6.99417 -3.01637 -378 2 5.9729 15.9975 14.2655 4.1321 -4.56061 -2.72375 -379 1 3.84883 6.51764 1.70764 -0.24517 -12.2729 -5.84301 -380 2 3.34882 7.24325 1.31145 3.38543 6.95106 5.25371 -381 2 3.97654 6.73657 2.63696 -3.88246 4.168 -0.0932901 -382 1 3.88114 11.6142 12.2659 5.57001 4.81087 6.19714 -383 2 4.75444 11.9544 12.4977 1.45427 -2.38077 -3.49117 -384 2 3.27884 12.2304 12.6965 -5.21243 -4.02352 0.863052 -385 1 5.43603 3.86764 15.8623 7.54926 19.6814 5.52869 -386 2 6.13377 3.21124 15.7334 -3.30504 1.34649 -4.68995 -387 2 5.89589 4.73554 15.9355 -10.2176 -19.0214 -2.32011 -388 1 14.4546 10.3201 4.4055 -4.6195 -17.8145 -6.66778 -389 2 14.5894 9.8066 5.2203 1.29615 2.58376 -6.73886 -390 2 14.6351 9.71867 3.64602 0.226975 12.0799 18.4878 -391 1 7.91148 17.3357 9.20787 -1.7112 -7.64626 2.59046 -392 2 7.14677 17.4921 9.78359 1.89149 7.49144 -9.53339 -393 2 7.98506 17.9868 8.49476 -7.16328 0.988414 5.46347 -394 1 4.5072 14.4394 3.95775 1.71054 11.4257 7.67338 -395 2 4.60793 15.3916 4.19235 0.708777 -20.878 -0.615863 -396 2 4.75094 13.8726 4.71695 -2.09911 13.0171 -9.33913 -397 1 14.3103 7.38832 15.7657 0.217846 1.64546 9.18842 -398 2 15.2433 7.23588 15.5844 -0.0812074 1.42566 -0.574095 -399 2 14.3036 7.75428 16.6621 0.0607731 -0.988243 -5.21848 -400 1 2.8988 18.2304 1.89629 8.58281 11.0644 9.98123 -401 2 2.46496 17.5082 1.44481 -2.59003 -3.64619 -8.76243 -402 2 2.19471 18.7603 2.28641 0.940953 -0.0494932 1.95923 -403 1 7.97286 1.6093 4.54004 -3.7555 -8.8471 12.6183 -404 2 7.33734 2.04506 3.96057 8.79876 5.02214 -6.32296 -405 2 8.86006 1.965 4.43164 -2.78989 3.02833 -7.03085 -406 1 2.61876 14.1356 17.7492 -10.3822 -13.3904 -3.64852 -407 2 1.93119 13.4601 17.9363 9.46205 16.209 2.13837 -408 2 3.45643 13.7285 18.0162 -4.37303 1.24885 0.341178 -409 1 0.743255 1.70456 13.8731 3.59522 3.89384 -8.23695 -410 2 0.90651 1.38191 14.7629 -6.62821 1.47751 3.8543 -411 2 18.4338 1.82907 13.7582 5.96409 -0.15878 4.57237 -412 1 4.54424 18.6047 13.95 -3.57477 5.05027 -2.13798 -413 2 5.48468 18.3837 13.9843 -5.3566 -3.00882 -0.547935 -414 2 4.15141 18.3634 14.8001 4.77528 1.99072 0.545271 -415 1 7.0969 0.526127 18.3635 1.96349 3.45814 -4.17057 -416 2 7.27221 0.201121 17.4702 1.10961 -1.44826 4.33327 -417 2 6.13787 0.588122 18.4485 3.2238 7.1666 2.24 -418 1 16.0917 18.4266 14.1084 2.59329 0.57669 -10.3481 -419 2 15.3502 17.9157 13.7545 1.31994 6.64432 9.22997 -420 2 15.9271 18.7357 15.0116 -3.89333 -11.6647 -1.43214 -421 1 10.0733 4.52495 16.275 12.9842 -2.30982 2.85456 -422 2 11.0043 4.70153 16.4703 -2.64404 5.32532 -3.085 -423 2 10.0864 3.57376 16.1251 -6.72333 -0.470122 -1.54666 -424 1 15.8636 17.8904 4.42819 -6.03116 8.53171 5.31621 -425 2 16.3871 18.7073 4.48664 -0.23776 -8.88425 -2.03055 -426 2 14.9745 18.1441 4.72479 9.46919 -4.85854 1.60726 -427 1 6.9475 17.372 13.7315 15.8768 1.84738 17.2901 -428 2 7.36738 17.5483 14.6019 -4.78498 1.02898 -17.1267 -429 2 7.68915 17.2477 13.1142 -8.54431 1.43966 5.77183 -430 1 13.2923 6.53747 6.71701 -11.5961 -7.93952 14.6915 -431 2 14.1983 6.84596 6.64723 3.17712 4.25021 -11.0614 -432 2 12.8934 6.43009 5.84838 7.58936 1.28323 -8.80485 -433 1 7.69653 2.37351 9.2065 12.517 1.33593 -3.6252 -434 2 7.21057 2.29 10.0355 -5.39375 -0.506169 -1.44147 -435 2 7.12159 2.1318 8.46594 -3.32624 -2.43573 8.05936 -436 1 15.157 14.8759 13.6545 4.5209 -3.06988 2.24561 -437 2 15.0369 15.0852 14.5928 -3.37623 1.75424 -5.30162 -438 2 14.3708 15.1144 13.1546 1.18854 2.2818 3.55032 -439 1 9.31032 8.32311 3.71462 16.317 -0.492826 6.27183 -440 2 10.1522 8.77498 3.89843 -7.06732 -0.949504 -0.86517 -441 2 9.4815 7.39306 3.91425 -6.58464 2.05554 -3.01208 -442 1 17.7054 13.4931 16.4528 -2.79698 17.5255 -9.98682 -443 2 16.7518 13.3863 16.3682 2.15912 -8.30505 3.41837 -444 2 17.8443 14.3312 15.9805 5.97419 -5.13367 5.17943 -445 1 5.02162 10.6562 2.64136 -2.02283 -9.27068 2.47877 -446 2 5.69056 10.1772 3.15718 -2.95942 7.94984 0.663407 -447 2 4.59516 11.2797 3.2389 2.78246 -2.35968 2.10645 -448 1 3.7261 8.35111 10.2906 -2.0647 -5.12326 -12.4171 -449 2 3.87558 9.26669 10.0174 -1.23075 2.88832 6.28188 -450 2 3.61938 8.33938 11.2471 1.47542 3.72119 -0.959794 -451 1 16.077 7.09208 6.26442 0.512876 -15.8531 0.565556 -452 2 16.8498 7.55114 6.61759 -4.58181 2.74438 -1.19615 -453 2 16.2841 6.14901 6.36212 0.103861 8.35624 -6.71996 -454 1 15.1586 7.03156 9.12145 1.35056 8.00181 -20.3615 -455 2 15.9739 7.38238 9.50783 -5.19642 1.69713 -0.962803 -456 2 15.0724 7.48187 8.24992 4.14438 -5.93719 19.2407 -457 1 6.4279 13.1173 12.8809 -5.50985 -11.8139 -9.3985 -458 2 7.12916 12.5687 13.2568 1.68182 7.24531 -2.67671 -459 2 6.29661 13.8986 13.4214 -0.338885 -0.946459 7.65298 -460 1 12.1214 4.48617 13.0834 13.9874 7.50725 -12.3985 -461 2 12.203 4.65044 14.031 -7.85782 -1.77094 2.73271 -462 2 11.2673 4.11709 12.8488 -4.68474 -5.36964 10.3853 -463 1 11.3361 8.19542 7.84742 15.1179 -11.1226 16.1752 -464 2 12.0446 7.62229 7.53485 -1.89389 0.170875 -13.8157 -465 2 11.6069 8.28902 8.77112 -9.48953 8.11742 -0.143346 -466 1 17.184 10.7876 7.43369 13.5323 -0.921102 -17.174 -467 2 17.9233 10.1981 7.20811 -10.1233 -1.22821 11.3165 -468 2 17.1161 11.3267 6.63249 -5.49276 7.55364 9.36769 -469 1 5.23991 18.1348 11.0582 -10.3762 -3.21686 -5.77572 -470 2 4.63631 17.985 11.8048 7.12888 1.45886 -5.61107 -471 2 4.69408 18.0516 10.2533 5.93648 2.65605 9.16476 -472 1 7.56507 17.5919 1.8299 2.38736 9.59194 1.23507 -473 2 7.95273 16.7967 1.45285 -6.05148 -1.8022 -9.76241 -474 2 7.59068 18.2848 1.14776 -2.89899 -11.2976 1.8216 -475 1 1.88529 12.921 13.6059 -1.54804 -3.98178 5.6231 -476 2 1.43748 12.3178 14.2147 5.26513 0.934067 -3.79148 -477 2 2.14524 13.6768 14.146 -0.717118 1.88599 -5.70238 -478 1 9.71545 6.78651 14.8047 -15.2171 15.1422 7.50698 -479 2 9.90531 5.90708 15.1331 4.86835 -12.5985 -3.10865 -480 2 10.0627 6.91606 13.92 3.16992 -4.80507 -4.41639 -481 1 15.2317 4.3547 10.7806 -19.2619 -13.8042 -17.3299 -482 2 16.1692 4.17769 10.7161 9.63774 3.67614 12.8518 -483 2 15.0389 5.06132 11.3962 11.3469 5.0749 6.12787 -484 1 11.2086 6.13697 0.180528 -13.4008 -14.4307 -10.9666 -485 2 11.2654 5.18187 0.0337896 12.1183 5.06406 4.26486 -486 2 10.2799 6.29806 18.6081 2.85376 11.1709 5.84358 -487 1 0.155975 11.3317 15.1259 -12.2739 12.4049 -22.3111 -488 2 18.2869 11.6878 14.3448 9.29886 -6.35489 23.8975 -489 2 18.7388 12.0248 15.8046 -8.78344 -4.02614 -5.34871 -490 1 7.07225 9.17108 7.27057 -4.95781 3.28344 -6.42365 -491 2 6.44778 8.45946 7.46529 5.34767 -0.253084 5.87629 -492 2 7.94637 8.76128 7.25029 -3.14507 0.531691 2.27088 -493 1 18.4147 15.4309 12.3592 -5.86353 -0.606553 -5.09086 -494 2 0.72281 15.5186 12.2612 4.29187 -2.85716 2.67478 -495 2 18.0791 15.7216 11.5043 -3.32345 0.421348 1.66841 -496 1 16.5543 4.36503 5.23509 20.0373 -2.39618 26.5758 -497 2 16.7455 4.21973 6.1845 -16.121 -2.23612 -11.2684 -498 2 17.4558 4.42117 4.89188 -6.1573 5.26009 -14.9538 -499 1 17.766 3.07261 10.7271 -5.62269 10.8805 -1.85707 -500 2 0.0408353 3.2985 10.945 -3.12308 -7.03453 -2.35326 -501 2 17.719 2.23067 10.252 6.41295 1.44898 4.1666 -502 1 12.3026 0.0397215 10.1517 -5.9029 17.7484 6.25384 -503 2 11.458 0.404705 10.4688 2.82225 -9.87605 -6.68676 -504 2 12.8944 0.808865 10.1781 1.22751 -9.09827 -0.112681 -505 1 10.357 9.81077 12.3435 10.1956 0.0137966 -0.104503 -506 2 11.132 9.85287 12.9219 -4.83247 1.57396 1.64677 -507 2 10.2731 8.87192 12.148 -4.78867 -1.2901 1.32484 -508 1 0.505846 2.83821 7.01562 3.91094 -2.13436 13.3247 -509 2 0.681162 3.5182 7.67504 1.89272 4.99945 -7.1411 -510 2 0.694039 2.0503 7.53478 0.801338 -5.04329 -7.26695 -511 1 0.437103 15.2686 6.90942 10.3075 -26.8847 6.28938 -512 2 0.575652 15.2733 7.87231 -4.50905 3.86257 -7.07916 -513 2 0.764375 14.3681 6.66626 -11.1886 22.2654 -1.84191 -514 1 16.9895 7.01682 15.3107 -21.8777 2.45652 -5.46979 -515 2 17.7216 7.6089 15.1142 9.4824 -7.00642 -0.959024 -516 2 17.2645 6.09907 15.4073 14.9833 2.67634 2.96399 -517 1 9.01274 12.4171 8.12853 10.6441 15.1284 15.6095 -518 2 9.41612 11.8292 7.47716 -12.8498 -4.61215 -9.56742 -519 2 8.05003 12.5053 8.0704 6.97129 -9.84551 -10.1137 -520 1 1.26391 1.92336 3.04659 2.32337 -11.3487 -0.982019 -521 2 0.972058 2.42084 2.27545 2.43588 3.35199 3.68236 -522 2 1.90572 2.43981 3.5544 -5.46738 3.49891 -6.33947 -523 1 4.13143 15.1122 9.67174 -10.3949 2.47722 13.8895 -524 2 4.06276 15.2642 8.72313 5.39511 -1.60046 -0.0768584 -525 2 4.99495 14.7433 9.87874 3.88633 -1.07729 -6.21534 -526 1 7.19145 2.18155 14.5787 4.86443 0.520714 0.489557 -527 2 6.89453 1.81445 13.7426 1.87671 -5.23084 1.53267 -528 2 7.73681 2.92919 14.317 0.289792 2.5421 2.67041 -529 1 18.6 14.6947 2.16091 -2.26171 3.41683 0.482467 -530 2 0.820032 15.117 2.19003 5.03273 -5.31768 -1.38278 -531 2 17.9827 15.4314 2.17519 -7.65677 -2.44766 2.74205 -532 1 9.95161 2.77613 12.9401 9.45852 -1.28953 0.462065 -533 2 9.84872 2.18467 12.1812 -5.82301 1.90383 1.05008 -534 2 9.27924 3.46642 12.8986 -6.28602 -3.28272 -2.83121 -535 1 2.83159 8.92314 13.0298 -5.32883 -6.03653 -2.71455 -536 2 3.23927 9.77312 12.842 3.02047 6.8466 -0.359778 -537 2 3.51958 8.34046 13.3637 5.40811 -1.61307 4.23789 -538 1 3.22435 8.37789 3.65229 -1.03338 2.31116 19.4552 -539 2 3.68753 9.01983 3.09696 -0.346577 4.63804 7.35474 -540 2 3.38788 8.57936 4.60408 0.951973 1.27409 -22.7571 -541 1 5.6137 7.19416 8.52025 7.21613 5.80474 -6.44533 -542 2 5.78863 6.24316 8.52523 -9.99458 0.454093 3.85202 -543 2 5.0179 7.43184 9.24037 0.527922 -7.72891 3.36669 -544 1 14.8805 1.29251 2.00129 6.0675 21.6566 -5.88084 -545 2 14.8065 2.10545 2.50153 -6.7285 -1.94379 16.9269 -546 2 15.1655 1.66296 1.16284 -0.437229 -14.9075 -12.229 -547 1 8.26451 15.1933 0.836486 3.22704 -2.0235 12.9462 -548 2 8.92324 15.2163 1.54184 12.9519 -3.35665 -8.03315 -549 2 7.55879 14.6837 1.25205 -6.95241 0.364363 -7.46808 -550 1 15.625 1.34415 7.23495 -17.3283 -0.11068 -5.87671 -551 2 14.9596 0.769214 6.81661 10.6011 2.38946 3.65492 -552 2 15.1493 2.17629 7.38417 4.13791 -2.68619 2.35471 -553 1 4.93041 13.0764 18.5264 9.84655 1.48115 -2.02825 -554 2 5.35318 13.1968 0.744685 -3.49153 -1.64799 -2.34468 -555 2 5.56664 13.4414 17.8965 -2.33559 -1.35641 1.38511 -556 1 15.3557 8.48379 18.1448 0.204246 14.4785 -5.82183 -557 2 15.7265 9.09289 17.4831 -0.830936 -8.68367 1.885 -558 2 15.168 9.07051 0.245745 1.7123 -4.50429 2.39894 -559 1 12.0892 3.02993 18.3645 -15.9576 34.4498 -4.49703 -560 2 11.9769 2.60431 0.571005 13.6468 -16.1673 -1.05926 -561 2 12.5269 2.48004 17.7153 4.47893 -15.6345 5.41851 -562 1 13.2117 12.674 5.1931 -10.339 11.1011 -13.5125 -563 2 13.668 11.9204 4.80624 6.1285 -2.92776 7.79567 -564 2 13.4681 12.7869 6.11335 2.67539 -7.97004 0.458585 -565 1 6.0506 7.06933 0.0406962 1.31452 -3.72946 4.6718 -566 2 6.04306 7.98784 18.9476 0.374235 14.6189 -4.65006 -567 2 5.24553 6.71887 0.435288 -0.866845 -3.58603 0.782556 -568 1 17.739 15.9899 15.0125 -12.5206 6.16285 -12.4036 -569 2 16.945 16.5161 15.03 -7.46495 5.1976 21.0221 -570 2 17.8264 15.955 14.0627 17.7161 -15.0875 -11.5838 -571 1 13.1794 1.00208 16.5735 3.37979 -5.34722 -6.70143 -572 2 14.139 0.860857 16.6169 -5.21536 -1.33728 6.50102 -573 2 12.8035 0.137283 16.3512 2.48828 2.22182 6.02943 -574 1 11.096 14.5828 7.22348 0.0189977 4.74793 7.83345 -575 2 10.4045 14.1614 7.73717 -8.54387 -1.14011 0.371667 -576 2 11.8979 14.1335 7.50232 3.58446 -6.30574 -4.63725 -577 1 17.5104 8.62105 2.08846 14.2737 4.97696 2.51664 -578 2 16.6904 8.42754 2.54903 -5.27316 -4.4343 -3.04137 -579 2 17.6167 7.98338 1.37729 -7.36397 -7.55614 -1.26172 -580 1 12.3515 7.96855 1.99107 6.37927 0.258975 7.77687 -581 2 12.1159 8.90068 1.90258 -3.43959 -5.51169 -5.98444 -582 2 11.9581 7.4701 1.26507 -2.67829 1.90847 0.988543 -583 1 11.8954 14.6159 10.3514 1.85125 4.19108 3.73581 -584 2 12.1615 13.856 9.81631 -7.50724 5.70574 2.33101 -585 2 10.9524 14.815 10.2079 9.27078 -9.38408 -0.682121 -586 1 6.88225 7.03081 15.6002 -4.063 -7.66118 -6.77733 -587 2 7.75096 7.17076 15.1857 -5.63662 2.89282 10.0227 -588 2 6.77779 7.6167 16.36 6.70206 0.515961 -5.66863 -589 1 8.00078 4.70171 13.472 -1.59283 -4.83357 -4.64481 -590 2 7.27623 4.81783 12.8396 5.32657 -1.99722 0.885811 -591 2 8.48998 5.527 13.4768 -0.383179 2.4117 0.469228 -592 1 13.3975 12.1709 14.2706 1.21587 3.44049 5.53322 -593 2 13.2724 11.2098 14.2197 -1.68144 4.93388 -3.39254 -594 2 13.8611 12.4606 13.4725 -0.646036 -5.76058 -0.123004 -595 1 14.8166 9.4384 7.29692 -7.31149 -4.84482 -6.71483 -596 2 15.6063 9.98387 7.39943 -3.2576 1.32409 4.65546 -597 2 14.0612 9.86586 7.70853 4.31514 4.68737 1.52589 -598 1 12.6657 17.0265 3.08863 -0.499632 18.4226 10.5493 -599 2 13.0409 17.4141 3.89779 -4.03665 -9.69042 -5.1428 -600 2 12.0457 17.7132 2.78031 5.51866 -13.6109 -0.0343421 -601 1 1.16791 7.14337 17.4519 -17.3777 -0.471365 -9.17207 -602 2 0.285968 6.88879 17.7816 4.71885 8.57951 0.206219 -603 2 0.996987 7.64547 16.6337 5.09703 -7.79381 5.85561 -604 1 12.7928 5.13809 15.6672 21.9233 -6.79759 1.12632 -605 2 13.5314 4.49934 15.6812 -12.3388 3.06691 0.377185 -606 2 13.2535 5.99313 15.6546 -7.1176 -2.71451 -0.771614 -607 1 2.50804 3.40102 5.01245 -9.19737 1.42964 37.6951 -608 2 1.85734 3.08405 5.69632 14.2768 7.06331 -19.9109 -609 2 3.04485 4.07021 5.49582 -10.9118 -9.07044 -17.2872 -610 1 8.33238 11.2579 13.4651 -31.1482 13.4197 6.60268 -611 2 8.24927 11.0816 14.4232 19.8118 -8.42601 -14.5581 -612 2 9.11403 10.9307 13.0113 5.91799 -11.9552 15.0186 -613 1 12.8978 1.37199 13.3367 -3.68795 11.8567 -21.2004 -614 2 13.3586 1.33808 12.4821 5.12584 -5.42725 10.3839 -615 2 12.3812 2.18266 13.2296 0.582289 -3.8456 10.447 -616 1 6.35916 13.6786 2.13932 11.022 -2.36774 12.7417 -617 2 5.81416 14.065 2.83164 -5.92624 2.48265 -4.44044 -618 2 6.97105 13.1303 2.64934 1.90703 -2.61302 -7.4669 -619 1 15.9256 6.59608 12.7788 -4.50753 -7.00075 -5.11208 -620 2 16.441 7.14613 12.1828 -0.0403293 3.27533 -1.15613 -621 2 16.337 6.66123 13.6439 3.64448 2.92523 3.21919 -622 1 16.8436 0.710185 9.59384 -10.8386 -3.59173 0.641976 -623 2 16.678 18.424 9.8391 7.1202 6.86076 -6.23598 -624 2 16.34 0.863872 8.77611 6.63769 -2.37412 0.960785 -625 1 6.14874 11.7365 8.37914 -9.33508 -33.9533 -7.34454 -626 2 5.23473 11.5355 8.67103 13.3879 7.28881 -1.35634 -627 2 6.50048 10.8558 8.08418 -3.72877 24.3898 8.07481 -628 1 2.86629 8.64627 0.414665 29.1459 -9.93647 1.24251 -629 2 2.37091 8.1673 18.3782 -14.09 11.8062 8.4924 -630 2 2.39345 9.32329 0.907466 -18.2396 -1.77699 -9.50941 -631 1 10.1496 10.4602 6.51654 2.68196 -4.3054 1.18084 -632 2 10.6351 9.79475 7.02051 -3.21697 0.687034 0.899044 -633 2 10.5797 10.4719 5.65285 -1.94715 4.18574 1.72512 -634 1 6.74842 15.6916 6.55665 -2.66838 16.8954 6.36263 -635 2 7.13132 16.1354 7.32023 -0.325366 -7.45035 4.57015 -636 2 6.8063 16.3799 5.88394 5.31174 -8.689 -7.83261 -637 1 6.45137 13.1469 5.60457 -4.49761 -5.86725 0.527716 -638 2 6.60666 13.9979 6.03098 2.95924 -2.27328 1.19215 -639 2 5.97977 12.5923 6.23705 2.74812 2.58161 1.74453 -640 1 16.8067 12.5538 9.81832 0.32671 -4.80998 5.18546 -641 2 16.9975 11.894 9.13199 -1.38663 9.72579 -2.40586 -642 2 16.8023 13.4365 9.43343 1.83869 -5.34542 -5.01893 -643 1 6.05747 2.94525 2.83457 1.69886 0.640591 -2.15275 -644 2 6.28227 3.83854 2.57267 5.15417 9.09864 3.82618 -645 2 5.67557 2.57416 2.03485 -2.61266 -9.3622 -0.552159 -646 1 10.8942 3.30264 3.28891 6.21412 -5.01644 3.41466 -647 2 10.2824 3.98758 3.58006 -2.01501 -0.119341 -5.67488 -648 2 10.543 2.90591 2.48434 -5.60317 1.35459 0.297545 -ITEM: TIMESTEP -30 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.7097 7.05343 17.9609 20.7509 -2.32452 -4.15205 -2 2 7.78893 6.94819 18.1674 -15.0431 -3.26874 3.90688 -3 2 8.91258 6.41114 17.2706 -4.14568 0.140094 0.745653 -4 1 18.6207 8.28878 6.84456 -10.9758 14.7568 -16.4597 -5 2 0.033254 8.12327 5.87995 7.78297 -6.3031 11.7942 -6 2 0.390602 7.58629 7.343 9.14113 -10.4614 1.3502 -7 1 8.4202 18.5906 6.81681 -12.3331 6.77681 2.70587 -8 2 9.32414 0.194792 6.65918 12.4366 2.53215 -2.1327 -9 2 7.89923 0.683074 6.46691 2.1768 -2.64942 -1.08929 -10 1 6.58134 1.82408 11.6823 -18.6778 6.99539 14.5251 -11 2 5.88329 2.28495 12.2086 12.5233 -11.9933 -14.8966 -12 2 6.20729 0.949756 11.4934 -0.484037 1.974 1.03676 -13 1 7.10261 5.71907 2.36398 18.2567 -30.46 4.77574 -14 2 6.748 6.26194 3.05915 -16.1408 13.0855 0.817955 -15 2 6.89353 6.07497 1.50557 -7.56713 14.4666 -6.71064 -16 1 16.2146 10.1912 16.1045 25.8326 -16.9059 -6.28167 -17 2 17.1924 10.2614 15.9892 -26.0275 4.96146 3.01812 -18 2 15.8649 11.0425 16.3511 -1.01593 12.6392 3.03555 -19 1 10.6309 14.9782 2.32852 5.54907 12.6484 -4.66534 -20 2 10.5683 14.607 3.21596 0.623447 -1.40903 0.430751 -21 2 11.0949 15.8303 2.43151 -6.58286 -12.6372 2.6945 -22 1 17.1592 8.25618 10.4876 -10.0218 -2.97818 8.46282 -23 2 16.7485 8.99843 10.9576 2.65758 -6.15573 0.24812 -24 2 17.9939 8.575 10.1448 6.84049 6.50961 -0.847785 -25 1 14.8275 15.8902 16.3678 -10.7483 8.55828 -7.5541 -26 2 13.911 16.2262 16.382 8.40977 -5.5752 2.0788 -27 2 14.9328 15.3229 17.136 -2.68587 0.983086 7.72287 -28 1 12.1445 13.398 0.450021 7.16446 -9.51802 2.88894 -29 2 12.0254 13.4023 18.1304 -4.57533 9.09159 6.34311 -30 2 11.5749 14.0284 0.911779 -3.72154 -0.858053 -5.79964 -31 1 9.27791 5.43254 4.03115 12.5872 2.27984 -15.9713 -32 2 8.88042 5.04351 4.80522 -11.7175 -1.93285 8.71688 -33 2 8.63164 5.36398 3.31053 -0.238489 1.95718 4.1093 -34 1 1.81582 4.23406 11.6392 3.52665 -33.0533 9.77708 -35 2 1.78778 5.15359 11.8657 -3.54286 18.5189 3.84305 -36 2 2.12638 3.75505 12.4373 -4.00166 7.6753 -17.1576 -37 1 1.99877 6.82017 8.35649 4.97761 -1.46296 10.7796 -38 2 2.31944 7.23424 9.17304 -0.0326511 4.09138 -10.3959 -39 2 2.07937 5.88268 8.56766 -7.36821 -1.33929 -3.79841 -40 1 5.395 4.41162 7.94446 4.05063 -3.43427 6.53634 -41 2 5.41133 3.44966 7.94196 6.73946 -4.4132 0.768998 -42 2 4.74595 4.62804 7.28165 -7.35272 12.6119 -8.90882 -43 1 3.28409 2.93052 17.527 4.91883 3.31559 -8.51102 -44 2 3.97895 3.44036 17.0791 -2.08356 -9.03714 -1.68785 -45 2 2.70652 3.59221 17.9099 -2.28402 5.9437 7.00724 -46 1 7.47067 5.28165 6.09824 -7.47353 5.76211 -2.63966 -47 2 7.88561 6.05707 6.46631 15.843 7.70036 2.30241 -48 2 6.86027 5.05727 6.79609 -9.98425 -16.5426 3.24835 -49 1 9.77462 7.02047 11.9927 -3.16333 0.34511 -3.92757 -50 2 10.3836 6.39122 11.588 -5.90607 3.51948 -2.51732 -51 2 9.0529 7.19715 11.3548 12.4276 -3.26368 6.69514 -52 1 14.0466 3.57679 8.07144 18.6703 -0.348541 19.5758 -53 2 13.8937 4.22019 7.39343 -5.64007 13.0869 -9.16622 -54 2 14.611 4.0279 8.7381 -15.3074 -10.3909 -10.441 -55 1 4.67183 17.2138 3.98342 -17.1629 -17.7927 10.2823 -56 2 5.57476 17.4036 4.21567 13.953 12.775 -5.74716 -57 2 4.34342 17.7474 3.25626 2.59666 4.69733 -2.98879 -58 1 16.5112 16.6016 10.1232 -22.4077 14.5184 19.5552 -59 2 15.797 16.9077 10.7255 16.9762 -11.2391 -6.18282 -60 2 16.019 16.127 9.45142 2.29692 -6.2585 -6.10264 -61 1 1.96965 4.87893 0.40906 -10.7697 -8.55226 -4.93465 -62 2 2.66061 5.27529 0.941341 5.5274 3.49831 6.88318 -63 2 1.47511 5.62215 18.6951 6.32177 2.44726 -2.78863 -64 1 11.7331 13.3335 16.3023 -6.06186 -8.167 -3.78825 -65 2 11.2597 12.4992 16.3612 -10.498 -1.32756 10.0093 -66 2 12.2577 13.1697 15.5177 8.21427 7.2284 -4.69488 -67 1 10.121 11.0486 16.9167 -7.88764 10.2638 -1.90592 -68 2 10.5124 10.1783 16.9786 2.49636 -9.86729 -0.127492 -69 2 9.16626 10.9164 16.816 6.71354 -1.99355 -1.80005 -70 1 11.7161 17.4964 13.4564 0.653858 7.10726 11.4031 -71 2 12.4343 17.1488 12.9211 3.60089 1.57548 -4.57497 -72 2 11.8646 18.4589 13.5472 2.97554 -11.89 -7.13537 -73 1 6.3779 9.31416 12.2259 -8.95234 15.1635 22.3379 -74 2 6.77463 8.98312 11.4273 14.2971 -1.19702 -8.86117 -75 2 6.96666 9.97806 12.6372 -2.9053 -11.0825 -10.5803 -76 1 16.2282 12.7644 2.6938 13.255 22.6007 -2.42149 -77 2 17.0484 13.1981 2.39924 -4.54016 -10.6437 3.48813 -78 2 15.6471 13.522 2.85837 -6.5992 -7.46489 -1.32569 -79 1 0.640508 12.5852 5.88727 21.753 -1.83143 4.54161 -80 2 0.997304 12.3975 5.01963 2.04371 1.22983 -7.11515 -81 2 18.3646 12.7399 5.72186 -19.0302 3.73655 0.683884 -82 1 5.21387 16.4194 18.454 4.66732 -1.11443 8.72996 -83 2 5.89359 15.806 18.1817 0.824082 -8.56943 -13.0935 -84 2 5.59435 16.7978 0.603858 -5.48698 7.00748 3.62952 -85 1 0.548987 7.64401 4.10842 0.670348 4.32997 2.73018 -86 2 18.6015 7.92625 3.40384 -3.24873 3.72744 -1.92559 -87 2 1.36738 8.12724 3.94642 3.53853 -5.18785 -2.83474 -88 1 3.12734 8.93117 6.50347 30.4123 1.43415 3.20415 -89 2 3.68489 8.55498 7.21169 -11.4249 4.27745 -10.9708 -90 2 2.23185 8.74841 6.74202 -19.2185 -4.73256 7.28786 -91 1 7.31515 10.3274 16.2171 -7.5998 2.86538 3.08356 -92 2 6.58991 10.5191 15.6248 2.07633 0.375924 -7.53004 -93 2 6.86928 10.3012 17.0718 3.58834 -2.41696 5.50844 -94 1 11.1056 1.03439 5.00906 5.66297 2.87297 -9.25474 -95 2 11.3082 1.81468 4.47889 -2.42802 6.95123 8.17266 -96 2 10.7866 0.43271 4.33294 -5.36858 -10.0003 1.63315 -97 1 4.38851 2.75082 13.2055 -1.16421 16.6802 -23.4007 -98 2 4.78143 3.22961 13.9394 0.315345 -9.27332 13.6616 -99 2 4.20912 1.83275 13.4212 4.21877 -6.70893 11.8835 -100 1 8.39225 10.0828 1.81263 -0.204034 19.0364 -5.60934 -101 2 8.35289 10.7959 2.47026 -1.38438 -3.08289 -2.87504 -102 2 8.81547 9.35618 2.25702 3.41266 -13.1645 6.66357 -103 1 10.4926 1.73671 15.571 11.1439 -7.64614 -12.2914 -104 2 11.3949 1.40928 15.4244 -6.59208 6.73213 11.009 -105 2 10.2461 2.06593 14.699 -6.9068 1.71228 -0.826453 -106 1 2.72763 12.9186 7.78215 1.53907 -1.41162 9.17357 -107 2 3.36352 13.5565 7.43734 -3.21302 -0.65885 -4.12251 -108 2 2.22004 12.5809 7.03913 -2.76352 5.50699 -3.09439 -109 1 3.68558 11.672 5.21041 4.08504 4.36046 -3.38247 -110 2 3.45481 10.9554 5.79468 0.598863 -9.40064 6.30918 -111 2 2.92113 11.7973 4.6466 -2.33635 3.52119 -7.07475 -112 1 6.80415 14.4796 16.8864 5.34146 -11.2852 2.95693 -113 2 7.68462 14.091 16.8709 -3.70601 4.15103 0.993665 -114 2 6.49099 14.4407 15.9783 -2.62919 9.78665 -2.68056 -115 1 14.176 14.5561 3.39307 -12.5209 -3.15767 3.59597 -116 2 13.6245 15.3467 3.3085 5.15733 -4.43597 -5.06132 -117 2 13.635 13.92 3.89178 10.6994 6.10439 -0.0738324 -118 1 8.31018 18.1523 16.0453 25.0942 2.73084 1.98444 -119 2 8.89462 17.4796 16.3723 -6.95894 -25.3404 9.38217 -120 2 8.98968 0.119946 15.7574 -11.3153 21.4924 -7.69748 -121 1 4.73581 1.63729 4.92804 -12.581 -10.4736 11.5054 -122 2 3.83953 1.97889 4.8343 1.42607 1.89675 3.67103 -123 2 5.27039 2.18299 4.37483 11.2234 12.2757 -18.577 -124 1 15.0504 12.7475 16.4383 22.4341 -19.9388 -26.396 -125 2 14.708 13.1949 17.1966 -19.6268 9.49299 12.0559 -126 2 14.4413 12.6723 15.6738 0.429593 5.89098 19.3668 -127 1 15.7794 18.4162 16.8297 -23.8108 0.224717 -24.365 -128 2 16.2557 18.6157 17.6209 13.9809 -1.68 17.1984 -129 2 15.4229 17.5182 16.8969 9.44127 2.10519 2.83182 -130 1 1.1656 1.1613 16.5455 9.88565 -3.33075 -8.05438 -131 2 1.89055 1.78579 16.6066 9.02992 -0.102422 -1.61706 -132 2 0.673214 1.35844 17.3295 -13.4515 3.62078 11.8035 -133 1 18.1028 4.54571 15.8941 -4.73113 6.48399 7.96005 -134 2 18.5013 4.04336 15.196 5.27298 -10.1152 -10.2677 -135 2 18.7433 4.58481 16.606 1.22293 0.259147 -1.01212 -136 1 12.236 16.9836 16.146 14.9412 3.5391 -27.9779 -137 2 11.6416 16.3841 16.5672 -17.548 -8.54782 13.2608 -138 2 12.0887 16.8479 15.1863 -0.907912 9.23395 13.7712 -139 1 15.9498 2.53257 18.0253 10.6473 -13.6828 8.83411 -140 2 15.5627 3.24781 18.526 -5.22656 12.7326 -1.10284 -141 2 15.751 2.68965 17.0989 -3.04742 3.76351 -4.61681 -142 1 6.7038 13.8197 10.2271 2.9338 -17.2727 -3.34939 -143 2 6.61667 13.5512 11.144 -2.24755 5.72821 7.93099 -144 2 6.68776 12.9653 9.76874 -1.43812 10.35 -6.56898 -145 1 10.1318 18.2649 2.7724 -13.411 -9.16786 2.85058 -146 2 10.3828 0.244178 2.09267 2.54842 10.4954 -6.81354 -147 2 9.19143 18.056 2.59362 16.7762 1.59207 3.74676 -148 1 2.99108 17.7409 6.10283 23.0954 -1.76337 16.2177 -149 2 2.19234 17.7622 5.58671 -8.31269 -3.84851 -15.8536 -150 2 3.76803 17.7869 5.51609 -16.1123 2.00349 -4.76697 -151 1 12.5756 16.9274 7.99763 -5.18448 9.92793 0.0594024 -152 2 11.7822 16.4009 7.94219 -1.30832 -15.7704 -9.09049 -153 2 12.3073 17.5896 8.63909 10.7698 6.45321 6.22995 -154 1 14.8838 15.2691 8.24901 11.9288 7.15592 -19.4456 -155 2 14.3219 16.0313 8.11935 -17.9047 1.82161 10.6012 -156 2 15.419 15.3185 7.43747 0.964457 -9.38205 7.76842 -157 1 17.6242 18.2515 0.369787 17.475 26.3316 2.73311 -158 2 18.5101 17.9713 0.0958777 -8.0951 -12.2782 0.813683 -159 2 17.7821 0.518901 0.686034 -9.22006 -13.9572 -3.22273 -160 1 0.867554 10.3913 1.38534 13.3292 31.3771 -20.1166 -161 2 0.0708789 9.90853 1.49908 -23.2341 -17.8443 11.3974 -162 2 0.609768 11.125 0.785047 6.92113 -8.95227 10.8017 -163 1 1.63658 12.2225 3.36866 -7.99561 -17.8946 -31.9552 -164 2 1.35203 11.5128 2.74742 7.334 6.03534 21.6261 -165 2 1.63695 12.9742 2.77054 4.15295 9.67724 10.1418 -166 1 0.571199 17.2371 4.87124 -14.5407 6.59112 32.0774 -167 2 -0.059088 17.9662 4.92138 6.12201 4.50556 -13.0577 -168 2 0.445901 16.8548 5.75927 11.2459 -10.7393 -14.745 -169 1 1.10756 0.954018 9.42478 -6.01064 0.927768 -12.2971 -170 2 1.20282 0.614567 10.324 -1.80966 -3.76099 -1.37067 -171 2 0.239583 0.659806 9.09473 9.24115 0.27684 10.6776 -172 1 16.7657 2.33783 13.2856 -4.77092 -12.7415 18.4331 -173 2 16.9235 2.53629 12.3736 4.43968 6.32108 -18.3535 -174 2 16.5017 1.40258 13.3145 0.84997 6.98888 1.09187 -175 1 2.55595 15.84 12.1915 -9.99296 7.89206 -20.2214 -176 2 3.13585 15.4219 12.8083 9.49953 -6.79049 14.4751 -177 2 2.92245 15.6515 11.3148 -0.922807 -1.51117 1.32599 -178 1 16.4223 15.613 5.98575 -3.71667 -18.1819 11.7841 -179 2 17.3247 15.5921 6.33835 -0.216171 6.69275 -4.6749 -180 2 16.2529 16.4332 5.52058 8.23488 6.69239 -4.77655 -181 1 5.80627 5.05529 11.7835 2.20346 1.03406 8.57972 -182 2 5.47099 5.61389 12.5063 0.21977 1.29573 -10.4635 -183 2 5.43215 4.18052 11.9366 -3.48089 3.11082 -1.53573 -184 1 15.1897 4.8564 0.727292 -5.49239 9.65996 -2.72664 -185 2 15.2051 4.71263 1.67299 -4.1535 -7.09946 8.01526 -186 2 14.3467 5.30742 19.2217 7.5675 -5.77492 -4.69919 -187 1 16.3443 16.3423 2.09898 -10.6702 -0.501744 21.7899 -188 2 16.0343 16.7391 2.94116 7.72577 -10.997 -12.8868 -189 2 16.4832 17.1019 1.54751 7.961 8.6491 -12.4493 -190 1 0.271558 4.86315 3.80356 2.16636 -31.8967 4.70784 -191 2 0.500225 5.77685 3.71679 7.2244 19.9811 4.59738 -192 2 1.02077 4.40389 4.23265 -9.838 12.5034 -4.93629 -193 1 2.94659 15.0442 15.0679 0.642608 -6.50925 -4.27186 -194 2 2.75789 14.5701 15.8868 0.637625 5.4096 6.54553 -195 2 2.48063 15.8876 15.1248 -0.665005 -3.22304 2.52721 -196 1 1.13823 14.625 9.55769 -40.6641 2.98648 23.3687 -197 2 1.89308 14.4183 9.03602 24.2615 -17.8348 -5.78778 -198 2 0.899054 13.8694 10.146 16.149 11.9497 -18.7143 -199 1 13.6328 16.6228 11.5317 -8.77554 -4.828 10.6654 -200 2 13.2136 17.4084 11.1616 -1.58446 0.630618 -8.00902 -201 2 13.0391 15.8864 11.302 7.59245 3.60181 -7.14688 -202 1 4.70114 1.47286 0.734685 -3.14847 1.30924 1.42089 -203 2 4.10181 2.05657 0.255283 4.3012 0.912352 -3.9516 -204 2 4.12143 0.893804 1.23429 -1.01367 -7.44934 0.356301 -205 1 1.44259 18.5254 11.8725 4.87725 -20.5249 2.38925 -206 2 1.2982 0.329643 12.7089 -1.92821 4.76162 2.3937 -207 2 1.66413 17.5975 12.0994 -0.659414 17.7173 -3.45023 -208 1 11.5206 10.1171 4.06393 -3.80452 1.00663 -6.51606 -209 2 11.2843 10.553 3.23019 1.0155 -1.19537 2.23558 -210 2 12.4827 10.1039 4.08159 3.36054 1.41703 2.51077 -211 1 8.33991 12.1729 3.71569 5.40649 2.32091 -9.4304 -212 2 9.08268 12.7024 4.00206 12.7546 1.78956 -5.29094 -213 2 7.80528 12.1916 4.49536 -21.4073 -3.06625 11.8611 -214 1 14.3677 4.01314 3.28101 5.46562 4.88363 2.56432 -215 2 15.0857 4.19963 3.89805 0.543674 -3.28085 4.74869 -216 2 13.622 4.5498 3.58084 0.572713 -1.66955 -3.63784 -217 1 5.59145 1.71061 7.51389 3.0333 8.44076 -17.8773 -218 2 4.93757 1.09228 7.83941 -4.88752 -5.30351 6.58254 -219 2 5.37448 1.80426 6.56172 4.34195 -4.37145 14.4788 -220 1 17.8887 1.09435 4.8754 -0.773263 0.600717 5.02725 -221 2 18.623 1.41887 4.35928 5.70444 0.114988 -11.5441 -222 2 17.8389 1.7231 5.59879 -7.43418 -0.321368 4.00301 -223 1 6.81825 9.41317 4.48156 7.11204 -1.13267 15.9283 -224 2 6.84118 9.52277 5.44603 -5.88151 0.934362 -6.29355 -225 2 7.74851 9.26985 4.27279 -2.06614 -3.64671 -7.13223 -226 1 2.66566 14.925 1.97184 3.43761 -5.8072 22.4208 -227 2 3.31024 14.6851 2.65976 -11.6222 2.95672 -3.26291 -228 2 3.19272 14.9753 1.1906 5.92571 0.162325 -19.2981 -229 1 17.2917 12.9099 13.1468 13.6904 -32.8575 1.82925 -230 2 16.4305 13.254 13.3667 -5.78742 18.0954 -2.54799 -231 2 17.8833 13.5932 12.8229 -8.84805 15.1913 2.15275 -232 1 14.9839 10.5629 1.38454 25.7264 11.2091 10.263 -233 2 15.6084 11.2587 1.71974 -19.4135 -18.6888 -7.72567 -234 2 14.1549 11.0026 1.25075 -10.8149 6.915 -1.22185 -235 1 5.70372 6.84607 4.55662 8.80438 8.80025 -0.823305 -236 2 6.10735 7.7373 4.58073 -7.50282 -10.5851 -1.04914 -237 2 6.32636 6.24858 4.99 1.7616 -0.154003 4.43374 -238 1 8.04871 8.29405 10.2754 3.94684 3.34606 -22.4081 -239 2 8.71637 8.94856 10.0317 -1.03323 4.34225 9.84614 -240 2 7.78699 7.97842 9.39774 -4.16124 -6.72066 12.7971 -241 1 13.4913 18.3469 5.77892 -1.26098 13.9384 -13.7404 -242 2 12.815 0.368504 5.57583 1.14564 -3.93427 -2.76608 -243 2 13.0908 17.8361 6.47463 -1.65231 -11.4802 12.6171 -244 1 0.227007 2.59645 0.141675 -14.0496 12.7254 8.33212 -245 2 17.9751 2.93781 18.665 -4.73692 -13.8452 -6.2234 -246 2 0.694599 3.38298 0.431909 14.3746 0.669884 0.426623 -247 1 12.7219 11.0238 9.75183 49.8657 -12.692 14.413 -248 2 11.8223 11.0616 9.49871 -31.5247 -8.5727 -6.88909 -249 2 12.9406 10.0926 10.0008 -12.7634 16.4478 -4.29644 -250 1 0.765495 12.2256 11.092 -6.27201 -3.92882 -21.6672 -251 2 18.4439 12.3344 11.0429 5.26844 -2.50397 8.5312 -252 2 1.08097 12.384 11.9788 -3.27397 5.59862 9.72518 -253 1 5.06534 7.27352 13.4491 9.82463 3.8805 6.07585 -254 2 5.60445 7.97165 13.048 -4.44492 -2.76176 -4.56894 -255 2 5.50693 7.14172 14.2991 -3.01503 -3.24863 -0.495805 -256 1 1.24722 6.90803 11.85 29.2977 26.916 27.8288 -257 2 0.522094 7.24638 11.3513 -16.2758 4.78156 -11.2742 -258 2 1.67283 7.72942 12.2344 -11.891 -29.9717 -16.3043 -259 1 15.4903 9.51892 12.3126 7.40517 -6.095 -16.4028 -260 2 15.1231 10.4002 12.2744 -2.67202 9.46709 6.64342 -261 2 15.3464 9.12903 13.1709 -3.09066 3.82816 8.99587 -262 1 16.6298 12.8631 5.48891 1.11523 -3.92575 5.75418 -263 2 16.4995 13.8048 5.46845 -2.55881 16.2829 11.3267 -264 2 16.4805 12.6501 4.57692 -1.87933 -15.1854 -15.6508 -265 1 6.21094 9.97472 0.0957231 23.6487 -5.34392 2.82943 -266 2 5.60453 10.4038 0.703481 -3.26342 3.61778 2.3496 -267 2 7.09538 10.0231 0.521798 -18.1891 -1.30215 -0.820391 -268 1 12.348 6.08762 4.05307 2.0614 24.7942 -10.4953 -269 2 12.1492 6.85087 3.46448 11.8353 -14.4305 6.54315 -270 2 11.534 5.60454 4.05688 -13.4451 -11.2489 2.03158 -271 1 0.182227 12.8112 0.197519 7.97213 -0.157956 2.72486 -272 2 0.124577 13.5143 0.856815 -1.71897 -0.134619 0.137441 -273 2 18.3975 13.1734 18.0617 -3.09196 -0.84285 -5.0356 -274 1 3.77998 18.5905 8.57799 -18.8802 5.92516 7.26956 -275 2 3.52251 17.9827 7.88131 5.13558 -0.560148 -6.56591 -276 2 2.92387 0.359522 8.79319 10.0752 -0.462424 4.43469 -277 1 7.44275 17.2901 4.46744 -21.5086 -34.4409 7.51913 -278 2 7.83961 18.0981 4.73248 10.1677 27.4444 -0.194329 -279 2 7.33826 17.2675 3.51576 6.23588 9.30645 -6.08156 -280 1 9.24103 17.0711 12.2479 -19.3743 11.7076 -0.715804 -281 2 9.17102 16.3949 11.5719 7.91635 -8.00505 -0.934966 -282 2 10.0835 16.9964 12.6894 10.2718 -1.4174 0.528472 -283 1 13.295 12.9281 7.96455 10.8524 35.2373 8.53109 -284 2 13.4175 12.2933 8.66577 -5.31299 -13.0614 2.94334 -285 2 13.7676 13.7325 8.27776 -0.249345 -13.5851 -11.5496 -286 1 14.9473 2.96516 15.3472 -8.56764 -6.90335 7.41648 -287 2 14.4704 2.13858 15.1989 -5.86972 7.46703 2.11397 -288 2 15.5773 2.99488 14.6333 9.67131 3.29159 -8.66831 -289 1 9.8733 15.5399 16.9999 -1.15808 -3.26391 2.43146 -290 2 10.4067 14.7753 16.7398 -3.17357 -1.97936 0.56939 -291 2 9.29049 15.2638 17.7267 6.50431 4.19029 -1.43758 -292 1 11.3155 8.30103 16.5489 -8.97523 -12.184 6.64215 -293 2 10.5995 7.86385 16.0596 7.08532 7.34183 -0.412451 -294 2 11.4953 7.67267 17.2664 2.19784 9.25982 -2.90547 -295 1 3.86136 18.202 16.7472 -0.00540616 -19.6914 -20.2162 -296 2 4.27115 17.4628 17.2262 -1.12743 11.6131 4.05136 -297 2 3.85436 0.333712 17.2887 2.36829 10.2975 15.3313 -298 1 2.18996 4.14488 8.93819 0.886129 3.08448 -7.12661 -299 2 3.10445 4.02058 8.72725 13.9566 -1.85365 -12.2229 -300 2 2.19804 3.9794 9.87086 -10.6985 1.40109 20.9797 -301 1 9.87077 10.3617 9.71962 10.1113 -1.13074 11.4426 -302 2 9.57245 11.1887 9.34333 -7.01747 6.00246 -6.1834 -303 2 10.1269 10.5679 10.6319 -2.96085 -6.85282 -1.29137 -304 1 9.72151 0.827202 10.8565 -16.8019 0.79505 -1.6906 -305 2 9.17924 18.7332 11.1654 13.4836 -3.87865 6.80866 -306 2 9.14124 1.21724 10.1941 6.30814 7.82285 -3.72399 -307 1 9.21217 15.15 10.2242 6.46373 1.33184 2.55262 -308 2 8.76537 15.794 9.67699 -2.80645 8.81337 -5.09524 -309 2 8.53339 14.5081 10.4276 -6.91387 -6.36492 -2.48134 -310 1 0.979873 9.39617 10.3168 -32.1534 32.2854 2.26584 -311 2 1.01417 10.3672 10.3328 -11.1793 -7.1298 6.70775 -312 2 1.8685 9.20872 10.1515 40.6499 -19.8378 -9.87175 -313 1 16.9127 4.85919 8.18774 -4.59801 12.0977 -12.3954 -314 2 16.2737 5.53573 8.4435 0.928859 1.2732 2.05393 -315 2 16.9639 4.27263 8.93179 4.52425 -11.0836 8.47724 -316 1 14.6737 14.709 0.318185 15.3338 2.15239 -13.9805 -317 2 15.2295 14.9726 1.0606 -1.701 5.56475 -1.20644 -318 2 13.8551 14.4222 0.702232 -12.5496 -7.63291 5.74768 -319 1 3.57822 11.0521 9.58832 7.05767 -0.848593 3.86503 -320 2 3.70772 11.5491 10.4084 -2.82358 -5.49605 1.13538 -321 2 3.0796 11.6369 9.01245 -0.492053 5.16034 -4.32733 -322 1 11.1043 10.8166 1.33994 -11.5702 -13.9866 8.70354 -323 2 11.3928 11.6085 0.903197 7.06397 14.5046 -5.44138 -324 2 10.1649 10.7312 1.10986 7.36828 -2.13735 3.91294 -325 1 13.1846 7.09882 12.8318 18.6724 6.28095 -0.937746 -326 2 14.1536 6.98642 12.9472 -16.4658 1.64828 -3.93553 -327 2 12.8311 6.20921 12.7949 -4.05904 -6.33012 1.01947 -328 1 9.62724 1.89857 0.976269 -5.84048 -4.71512 -19.854 -329 2 8.85605 1.47112 0.556627 5.981 10.7585 7.84687 -330 2 10.1714 2.22507 0.238723 -1.51496 -2.73206 9.47681 -331 1 10.5937 13.5214 4.66199 3.2234 0.0339744 -7.62843 -332 2 11.4486 13.114 4.51461 3.39436 -8.72009 -0.849353 -333 2 10.7191 13.8974 5.52846 -5.55452 9.94363 9.85641 -334 1 14.3279 1.73837 10.9221 -6.80645 -20.6925 1.76137 -335 2 15.1234 1.41881 10.4767 1.97621 6.90305 1.731 -336 2 14.3743 2.69243 10.9875 9.24527 6.91542 -4.56959 -337 1 14.6348 12.3447 11.7069 0.143663 -8.85162 -7.69369 -338 2 15.3924 12.4169 11.1267 15.8185 6.23005 6.53749 -339 2 13.9779 12.0599 11.0796 -19.2308 -4.32411 1.56042 -340 1 8.24345 5.06862 9.81236 -2.43519 -19.796 -15.4196 -341 2 7.42328 5.28077 10.2334 -12.2119 11.2175 13.6651 -342 2 8.03366 4.19231 9.43495 14.0834 8.03075 2.78805 -343 1 1.55958 16.8456 18.3509 0.293915 -24.903 24.1992 -344 2 1.74487 17.2231 17.5072 8.4457 6.47265 -18.7434 -345 2 1.95964 15.9468 18.3277 -12.6492 15.8955 -3.16542 -346 1 1.46885 17.2295 15.3261 -41.9231 18.9429 7.61422 -347 2 1.60163 18.0716 15.7975 2.88525 -7.29411 -7.90761 -348 2 0.471438 17.1304 15.2829 39.2238 -5.53287 -0.382895 -349 1 3.69895 5.65007 6.13962 5.67498 -13.7905 -4.71311 -350 2 3.08621 6.15365 6.67268 -1.79156 10.6243 5.04455 -351 2 4.29662 6.26435 5.6935 -4.62364 1.91275 -0.121461 -352 1 12.3686 9.4572 14.1916 2.50325 4.1373 0.835901 -353 2 12.6534 8.64397 13.7789 7.43403 -8.19142 -7.10693 -354 2 12.2431 9.18714 15.1032 -3.68368 1.41273 6.14038 -355 1 4.03462 15.2828 6.91278 -20.0144 -6.90546 3.84648 -356 2 3.57361 16.022 6.48562 4.0204 -1.30953 4.99773 -357 2 4.97214 15.427 6.85986 17.0804 8.85667 -5.89205 -358 1 0.596937 8.57007 14.913 -2.82207 -2.34568 11.0967 -359 2 0.589839 9.51288 15.1099 0.171131 2.88226 -3.41975 -360 2 1.22453 8.45469 14.2015 6.96836 3.95738 -3.73783 -361 1 12.9772 8.31295 10.3135 -4.52981 3.4147 9.81026 -362 2 13.748 7.88649 9.95158 7.10588 -4.96512 -13.4998 -363 2 13.0418 8.05063 11.2408 -7.87478 3.04011 -0.538852 -364 1 15.3081 7.67138 3.5266 23.4653 37.2808 -10.5735 -365 2 14.5495 7.31548 3.08478 -13.5361 -20.5278 3.76808 -366 2 15.7097 7.21489 4.26906 -13.5998 -13.5183 6.32814 -367 1 17.3139 6.67347 0.0519528 8.75828 -11.5188 0.32751 -368 2 16.922 5.81479 0.236083 -1.36263 0.235584 3.31968 -369 2 16.5542 7.20912 18.4844 -8.7655 12.4237 -8.09845 -370 1 8.86065 6.91878 7.81669 10.1209 17.2302 -14.0365 -371 2 9.80786 7.17641 7.77744 -16.0922 -4.42618 4.57681 -372 2 8.74795 6.24147 8.48473 3.77983 -6.9476 8.96536 -373 1 12.3541 0.627989 1.20673 7.59332 -4.64776 2.86492 -374 2 13.2579 0.528374 1.53727 -3.51801 6.0046 2.76074 -375 2 12.2851 18.632 0.498856 -2.53947 0.382583 -4.14536 -376 1 5.64549 15.138 14.5235 -4.10456 -30.421 5.78959 -377 2 4.73353 15.1769 14.8501 2.72532 6.49481 -6.12593 -378 2 5.9656 16.0086 14.3294 1.76375 18.5631 -6.42604 -379 1 3.85619 6.49135 1.72458 1.34418 -5.76632 6.1851 -380 2 3.4082 7.28863 1.44351 -4.61345 8.91678 -8.73454 -381 2 4.04036 6.67595 2.65567 -1.04596 -4.79787 -3.17499 -382 1 3.88128 11.6181 12.3021 -8.90147 -4.54474 -0.675722 -383 2 4.76839 11.88 12.5585 3.1774 6.51538 0.922611 -384 2 3.25574 12.2257 12.7332 9.80963 -6.2977 -1.14662 -385 1 5.41097 3.86243 15.8619 7.77498 -26.7447 2.47729 -386 2 6.19051 3.2555 15.8125 -22.34 13.8462 -4.82428 -387 2 5.75732 4.74289 15.8731 9.06733 16.771 0.375084 -388 1 14.4275 10.3077 4.42737 -15.4583 -1.2468 24.8449 -389 2 14.4136 9.7945 5.25584 5.65105 6.60384 -6.24763 -390 2 14.7139 9.69599 3.76155 7.16087 -8.52398 -12.4829 -391 1 7.87022 17.3652 9.18307 -6.55512 0.129027 -0.760847 -392 2 7.04604 17.5698 9.62158 -5.94597 -4.85201 9.5143 -393 2 7.92762 18.0395 8.50377 8.60962 -1.46955 -8.60251 -394 1 4.50919 14.4633 3.94747 -3.26277 6.69504 -13.1744 -395 2 4.44326 15.3745 4.23469 1.61374 7.68172 -2.63862 -396 2 4.73121 13.9745 4.72809 3.38773 -13.7326 11.5154 -397 1 14.2916 7.39166 15.7799 -19.0102 -0.643935 -4.97281 -398 2 15.227 7.28492 15.6956 21.3172 -2.59108 -3.06 -399 2 14.1661 7.73476 16.6606 0.966931 5.43289 9.36717 -400 1 2.93597 18.2496 1.90178 2.72474 -19.4407 -7.90163 -401 2 2.41137 17.5137 1.50762 13.3283 19.165 4.04527 -402 2 2.31568 18.912 2.18531 -12.4791 7.28301 8.56329 -403 1 7.97625 1.60842 4.55987 -20.0747 11.2227 -5.58284 -404 2 7.40672 2.18903 4.02942 -3.00667 -10.939 3.58357 -405 2 8.83426 1.86357 4.26417 23.6954 -1.42515 0.234182 -406 1 2.55973 14.139 17.7235 4.4947 4.4122 -3.81652 -407 2 1.9869 13.4419 18.0532 -4.8721 0.171095 2.94118 -408 2 3.45785 13.8729 17.9629 -0.333069 -3.9381 0.822902 -409 1 0.778432 1.72633 13.8806 -27.0748 -1.51039 10.7449 -410 2 0.840363 1.33642 14.7677 3.59517 6.80992 -7.55552 -411 2 18.4512 1.86919 13.7675 25.1129 -0.50251 -4.23703 -412 1 4.5218 18.6217 13.9311 -26.2208 4.76485 6.31935 -413 2 5.44026 18.4597 14.0857 18.6112 -6.32709 -3.49173 -414 2 4.08533 18.4032 14.7706 3.39103 3.57256 -5.13956 -415 1 7.0966 0.590139 18.3583 40.0867 -7.03194 -16.485 -416 2 7.43029 0.218977 17.5038 -14.1267 7.45313 19.238 -417 2 6.15491 0.497007 18.3797 -17.6926 4.43938 -0.268226 -418 1 16.0869 18.4184 14.0665 12.1783 12.0602 19.9903 -419 2 15.2602 18.093 13.7757 -22.8702 -12.1677 -15.3509 -420 2 15.9307 18.6351 14.9998 9.22594 -1.26981 -3.76068 -421 1 10.0615 4.5254 16.2644 17.4965 34.4304 -0.599412 -422 2 10.952 4.96419 16.2693 -15.2122 -21.3498 0.578373 -423 2 10.2001 3.58581 16.3272 5.99955 -12.591 -1.94777 -424 1 15.8874 17.8488 4.44366 26.9944 -8.8935 -8.85545 -425 2 16.3583 18.6921 4.41154 0.375294 -2.3726 2.41747 -426 2 14.9936 18.0388 4.65191 -27.7242 10.9512 11.1951 -427 1 6.97313 17.3837 13.7492 -14.8371 0.980348 6.17816 -428 2 7.33935 17.5289 14.6184 6.46616 5.40365 9.01508 -429 2 7.73032 17.2786 13.1826 8.79779 -2.98362 -9.94394 -430 1 13.295 6.50203 6.69495 9.53809 17.2257 -14.0038 -431 2 14.0496 7.07319 6.46986 -0.499105 -8.31015 13.7378 -432 2 12.8724 6.42857 5.83749 -8.85952 -9.05901 -3.70628 -433 1 7.73318 2.36184 9.23357 -5.82839 -0.191385 25.6357 -434 2 7.13515 2.2598 10.0003 13.8878 3.27143 -3.38814 -435 2 7.19146 2.08044 8.50905 -8.01798 -3.82737 -18.8349 -436 1 15.1683 14.8678 13.6621 4.32457 -5.24538 6.92634 -437 2 15.0117 15.191 14.5524 1.96766 -1.10504 5.54809 -438 2 14.4461 15.1877 13.1369 -6.78809 4.58671 -11.3713 -439 1 9.33811 8.31525 3.72912 -3.71623 14.6513 -1.76526 -440 2 10.1422 8.72537 4.07444 1.32163 -4.04075 -0.39549 -441 2 9.3744 7.3721 3.88081 4.66337 -7.69389 3.46587 -442 1 17.73 13.5264 16.4473 3.62887 -10.5665 6.33517 -443 2 16.8053 13.2497 16.375 1.67263 6.91521 -3.1024 -444 2 17.8249 14.3621 15.9879 -5.28625 7.64018 -4.86126 -445 1 4.99014 10.6392 2.69296 -11.8842 10.0017 7.67541 -446 2 5.62836 10.2105 3.25699 12.1385 -6.17254 3.53336 -447 2 4.64978 11.3543 3.2597 0.304061 -9.29163 -9.90123 -448 1 3.7356 8.34279 10.2382 -0.81373 18.9096 -12.0232 -449 2 3.86658 9.26506 9.94102 0.197912 -10.4595 0.115104 -450 2 3.49052 8.44407 11.1547 0.601112 -5.92985 11.4704 -451 1 16.0428 7.05286 6.2029 -10.6575 13.2953 -5.82849 -452 2 16.855 7.48535 6.46978 4.82485 2.35526 4.73173 -453 2 16.1613 6.12013 6.32007 7.39497 -13.7867 -3.51418 -454 1 15.1327 7.05037 9.11575 3.87713 -5.32828 6.40762 -455 2 15.8626 7.43029 9.61535 2.26476 1.25298 1.00848 -456 2 15.1324 7.53151 8.29313 -1.46271 6.60183 -11.5025 -457 1 6.39444 13.0666 12.8402 5.00849 -18.9174 -4.31708 -458 2 7.14138 12.6166 13.2588 -1.3728 0.0732389 -8.28768 -459 2 6.25233 13.8543 13.3456 -7.70591 16.466 12.3405 -460 1 12.1285 4.48598 13.0882 -38.1563 -9.245 -8.92104 -461 2 12.05 4.67155 14.023 12.2106 4.08095 10.8898 -462 2 11.2367 4.10453 12.8753 29.4794 5.44987 -0.890783 -463 1 11.348 8.18475 7.8598 -17.4059 7.12531 -10.6431 -464 2 12.038 7.63484 7.48501 10.4081 -6.60064 5.31237 -465 2 11.4756 8.28116 8.80352 11.9689 -3.04214 7.26146 -466 1 17.1922 10.8074 7.44155 -25.4203 14.6985 18.6261 -467 2 17.9197 10.2075 7.32737 10.9985 -8.38668 -11.5183 -468 2 17.0629 11.3797 6.67504 9.09121 -1.65978 -2.87918 -469 1 5.25169 18.1248 11.0507 12.0648 3.50666 -3.83562 -470 2 4.62743 17.897 11.7414 -1.9785 0.423337 4.7613 -471 2 4.73712 18.33 10.2687 -7.94827 -3.02158 -5.48025 -472 1 7.57794 17.5568 1.83513 6.93874 5.3114 -35.8297 -473 2 7.86736 16.7596 1.34843 -3.99011 9.3379 11.9664 -474 2 7.57256 18.2518 1.1344 -7.92946 -12.1924 16.8763 -475 1 1.91036 12.9101 13.6013 -3.96045 -14.8375 -19.2024 -476 2 1.39392 12.2568 14.0828 0.939403 1.79227 7.54842 -477 2 2.06766 13.6568 14.1634 3.48639 14.3121 10.7878 -478 1 9.68075 6.78169 14.8149 2.18853 -17.0585 -1.56943 -479 2 9.86519 5.84438 15.0146 -5.66436 10.7434 4.7021 -480 2 10.1054 6.93436 13.9655 -4.91522 4.89205 -3.51643 -481 1 15.2489 4.31705 10.7696 10.3165 19.1063 17.7081 -482 2 16.2033 4.28261 10.8841 1.13215 -16.3849 -6.84609 -483 2 15.045 4.99149 11.4324 -10.9146 -3.35461 -8.40134 -484 1 11.2157 6.13912 0.184288 19.0347 18.6277 4.4365 -485 2 11.389 5.28379 -0.213728 -9.30505 -7.86745 -0.661886 -486 2 10.2971 6.41228 18.7766 -10.0409 -9.92482 -6.17869 -487 1 0.119384 11.3453 15.1007 -14.3711 11.1071 -8.9459 -488 2 18.1083 11.5338 14.3994 8.87914 -3.31428 2.86805 -489 2 18.675 12.1405 15.6491 -0.376992 -6.76779 4.41889 -490 1 7.06293 9.20482 7.26347 16.9728 2.93661 -2.33726 -491 2 6.45996 8.52415 7.5376 -12.746 -11.932 7.1182 -492 2 7.92776 8.76781 7.32981 -4.82181 7.51802 -3.03552 -493 1 18.3776 15.4097 12.3582 -11.3114 -7.16639 4.00893 -494 2 0.682756 15.4096 12.2525 13.0982 4.14044 -6.05458 -495 2 17.9899 15.7976 11.566 2.11158 0.973908 -1.02825 -496 1 16.5513 4.36706 5.24159 -5.09045 5.24791 -23.7034 -497 2 16.6166 4.33687 6.19466 14.1446 -5.59224 10.5876 -498 2 17.404 4.59908 4.81371 -8.86364 -4.80736 14.9956 -499 1 17.7417 3.09647 10.7341 0.291254 -10.6186 -10.4582 -500 2 0.00513181 3.34109 10.9087 8.18655 7.52385 6.55564 -501 2 17.8253 2.23203 10.2933 -8.67083 8.1401 4.47273 -502 1 12.2919 0.0227122 10.1361 2.29147 -28.3523 -7.04943 -503 2 11.4789 0.3695 10.4906 -11.5623 8.87459 2.77288 -504 2 12.9485 0.705533 10.1424 9.22066 20.6222 4.35768 -505 1 10.3653 9.79669 12.372 -8.95345 -3.20907 -9.5203 -506 2 11.0695 9.83133 13.0162 9.21286 -1.60231 7.36796 -507 2 10.2442 8.85709 12.1552 0.446892 6.98856 4.38647 -508 1 0.537603 2.83987 7.02256 -3.09155 -21.8169 -17.6677 -509 2 0.689112 3.48917 7.69969 6.81735 5.32415 12.4887 -510 2 0.745143 1.97019 7.39814 0.967775 11.9311 3.78775 -511 1 0.407687 15.2844 6.91114 -10.1505 12.0239 22.1786 -512 2 0.487576 14.9005 7.81264 0.770838 8.15944 -16.8401 -513 2 0.754028 14.6482 6.29753 4.41733 -17.9374 -4.37366 -514 1 17.0108 7.01877 15.2726 9.75856 -4.98107 -8.16179 -515 2 17.7945 7.53845 15.0774 -4.62906 13.8031 -0.900924 -516 2 17.4019 6.14594 15.3485 -8.43732 -9.20439 7.91006 -517 1 9.04118 12.4266 8.12126 20.8625 -13.8276 -21.4288 -518 2 9.31201 11.8186 7.41014 14.8696 5.22508 9.07579 -519 2 8.11227 12.3461 8.03152 -32.7632 10.2849 9.08461 -520 1 1.26557 1.8876 3.02782 9.65045 8.01813 1.36118 -521 2 0.751817 2.27104 2.32199 -7.08934 -1.28284 -8.05339 -522 2 1.78864 2.63408 3.35807 -1.4257 -10.3882 4.86199 -523 1 4.12138 15.1091 9.73113 11.5132 -2.98862 0.0844269 -524 2 4.08037 15.3711 8.80771 -6.64563 1.38763 -1.25331 -525 2 5.02377 14.7713 9.82789 -5.61093 0.302526 6.22582 -526 1 7.21558 2.18454 14.596 -3.30246 -13.7461 5.2135 -527 2 6.95017 1.78255 13.7582 4.82488 2.3919 4.06302 -528 2 7.77929 2.92256 14.3836 3.82883 9.51482 -6.38734 -529 1 18.5827 14.6796 2.1698 -24.3208 -2.36026 -2.50397 -530 2 0.827663 15.0286 2.10654 6.16868 9.29818 1.18622 -531 2 17.9285 15.4101 2.10387 15.0339 -9.50868 3.05979 -532 1 9.96457 2.76705 12.9307 -6.0306 9.60441 -0.715471 -533 2 9.81933 2.16697 12.1996 2.81266 -10.505 -5.71659 -534 2 9.23975 3.40361 12.8511 1.73763 -0.77134 6.44595 -535 1 2.86173 8.92609 13.0404 7.24036 -2.57601 -2.21085 -536 2 3.32754 9.76259 12.8684 -5.41233 -1.95407 1.34833 -537 2 3.53569 8.30272 13.3558 -0.616664 3.71534 -0.977901 -538 1 3.21505 8.40688 3.66968 15.7234 22.1036 -19.602 -539 2 3.76887 9.07341 3.20135 -16.7118 -11.852 2.14794 -540 2 3.39007 8.60458 4.57891 -0.363765 -1.98929 20.9454 -541 1 5.60252 7.19004 8.53175 5.86958 -4.86959 9.5617 -542 2 5.84506 6.27445 8.70563 -2.01066 -2.63063 -12.6146 -543 2 5.1548 7.42343 9.34691 -7.32508 9.6882 0.185442 -544 1 14.8904 1.34267 1.9851 -2.44355 -11.2972 17.4528 -545 2 14.6303 2.11535 2.51846 2.91157 0.487188 -15.3266 -546 2 15.025 1.53806 1.05778 2.17575 14.4946 -4.76666 -547 1 8.30348 15.1948 0.839181 1.62975 3.11742 -15.2912 -548 2 9.05101 15.1086 1.44328 -1.42893 -5.28711 5.64984 -549 2 7.54504 14.6965 1.17349 5.50357 -4.17517 7.24781 -550 1 15.6062 1.34647 7.22998 12.9139 6.24135 5.03718 -551 2 15.0343 0.764422 6.7383 -10.7397 -5.17 -5.22658 -552 2 15.1371 2.18077 7.35367 -5.42005 -2.19365 2.65732 -553 1 4.96367 13.0608 18.5175 -8.25637 -3.65043 -17.7207 -554 2 5.34878 13.2483 0.722802 8.16177 0.261597 12.4464 -555 2 5.65153 13.2431 17.8644 -2.22894 4.298 3.81358 -556 1 15.3614 8.50445 18.1376 -9.02232 -8.38547 12.9254 -557 2 15.7319 9.00583 17.4156 5.20151 10.9324 -8.24127 -558 2 15.1687 9.14311 0.198883 4.58141 -1.82544 -4.44514 -559 1 12.0904 3.05083 18.3558 5.74067 -18.2993 3.78166 -560 2 12.2947 2.48128 0.458355 -7.48955 9.04159 13.408 -561 2 12.4465 2.47277 17.6781 -3.43414 10.0689 -17.6065 -562 1 13.2065 12.6801 5.18634 5.84251 -1.21193 6.01102 -563 2 13.6832 11.8727 4.98831 0.374712 -2.89081 -11.6293 -564 2 13.5252 12.8732 6.07674 -9.12379 3.52213 -1.02632 -565 1 6.05538 7.10808 0.0622478 7.64822 4.54905 2.96407 -566 2 5.99209 8.01824 19.0386 -2.92171 -4.08442 -8.95141 -567 2 5.21644 6.68693 0.272307 -1.20959 2.69213 5.93171 -568 1 17.7218 15.9656 14.99 27.5308 -15.6865 18.0891 -569 2 16.9388 16.4863 15.1181 -14.3434 5.91292 -14.0866 -570 2 17.911 15.7342 14.0701 -14.8265 10.2647 -3.26624 -571 1 13.1712 0.994875 16.5867 2.52549 -1.56274 -3.32645 -572 2 14.0875 0.750433 16.7652 2.07951 0.899412 2.60052 -573 2 12.7522 0.177983 16.2988 -0.931869 -3.47373 4.92885 -574 1 11.0723 14.6005 7.26575 -13.1255 -10.0571 4.65979 -575 2 10.3507 14.0428 7.62559 10.576 8.81418 -2.61622 -576 2 11.902 14.168 7.50495 -4.44994 -4.81764 -1.49609 -577 1 17.5239 8.59779 2.09084 -4.28833 -20.5194 -15.9758 -578 2 16.6824 8.33187 2.48237 1.37862 7.81735 4.46419 -579 2 17.5834 7.99355 1.32242 5.93631 9.11716 13.4418 -580 1 12.3581 7.93946 1.97566 -1.89696 -6.27914 -3.50436 -581 2 11.9505 8.79823 2.04436 -0.86405 10.6038 1.69948 -582 2 11.9097 7.53044 1.22383 5.98844 -6.29912 5.7943 -583 1 11.9176 14.6241 10.3724 -2.87076 17.8373 18.3305 -584 2 12.1889 13.9308 9.80998 14.0474 -22.5763 -16.4958 -585 2 11.017 14.792 10.1004 -10.4734 4.60408 5.02203 -586 1 6.86179 7.0045 15.5825 0.298402 -7.5032 -11.9192 -587 2 7.72978 7.09161 15.1865 4.58892 -5.83629 -5.839 -588 2 6.8806 7.68521 16.2363 -7.39186 11.3873 16.6815 -589 1 8.0061 4.66768 13.4643 -26.1906 -20.4665 -29.1007 -590 2 7.40104 4.82554 12.6933 13.2028 -5.13213 23.0799 -591 2 8.47723 5.469 13.5831 13.4856 24.6751 2.60837 -592 1 13.392 12.1682 14.29 6.21681 3.24263 -1.56593 -593 2 13.3744 11.2127 14.1772 -7.69192 -2.80185 3.02585 -594 2 13.9051 12.489 13.5384 -1.40129 2.2659 -1.62493 -595 1 14.7806 9.45441 7.28093 -11.5532 20.7697 15.955 -596 2 15.4984 10.0862 7.4818 -3.61589 -14.7511 -6.73617 -597 2 14.0294 9.75726 7.82532 9.94729 -6.45384 -10.5104 -598 1 12.6903 16.9959 3.11063 13.9021 -20.0527 -1.11079 -599 2 13.0479 17.2495 3.95961 -1.86196 6.25123 9.18833 -600 2 12.0243 17.6278 2.88206 -13.6174 14.7021 -2.85583 -601 1 1.14933 7.13689 17.4392 -10.8552 -5.82346 1.42608 -602 2 0.254324 6.85235 17.6903 1.68989 10.0465 1.1249 -603 2 1.04814 7.64429 16.6282 0.816381 -0.80389 -4.56811 -604 1 12.8311 5.11146 15.6849 -17.6595 -4.33947 -1.38663 -605 2 13.5036 4.46543 15.459 7.94947 -3.95791 3.77703 -606 2 13.2565 5.97185 15.6774 7.16 2.75079 -1.64654 -607 1 2.47852 3.39671 5.05511 -15.8601 -20.9034 -7.20071 -608 2 1.89248 3.0773 5.76599 4.829 7.89548 -3.4806 -609 2 3.06433 4.04634 5.42706 4.34046 14.9349 7.02505 -610 1 8.31182 11.2281 13.4853 12.2486 -8.92827 -7.03776 -611 2 8.34382 10.988 14.3869 -16.2376 0.866389 37.005 -612 2 9.12412 10.7865 13.2309 -0.249665 2.67206 -26.3927 -613 1 12.9087 1.417 13.3166 0.0274524 -25.355 19.3096 -614 2 13.4801 1.21198 12.5759 3.32243 8.60198 -10.444 -615 2 12.4274 2.20637 13.1188 -4.80778 18.3372 -7.59901 -616 1 6.3961 13.6531 2.14242 21.3539 -7.72513 -19.5528 -617 2 5.86296 14.1246 2.76583 -10.9825 4.85946 19.6126 -618 2 7.0399 13.1177 2.63436 -6.77103 3.35988 1.82582 -619 1 15.9312 6.57282 12.7577 9.39393 9.94387 -6.4398 -620 2 16.4454 7.11896 12.1297 -10.141 -7.43973 7.84454 -621 2 16.2972 6.7745 13.6327 -0.398164 -4.05689 -3.4507 -622 1 16.8338 0.714138 9.59622 -4.58014 7.56344 -3.36861 -623 2 16.786 18.4184 9.78234 2.45796 -8.84878 0.088887 -624 2 16.3762 0.83732 8.75167 2.21028 0.792186 -0.559114 -625 1 6.14371 11.7069 8.36929 2.81279 3.26044 -4.5559 -626 2 5.21452 11.6136 8.62066 2.93526 -5.28935 1.80511 -627 2 6.46143 10.8412 8.07651 -3.38714 0.356066 2.25694 -628 1 2.85881 8.67012 0.388915 2.79689 11.0982 14.7719 -629 2 2.20875 8.30366 18.4701 -9.93413 -28.5632 -26.9968 -630 2 2.30006 9.32334 0.801848 8.26615 13.7996 15.8107 -631 1 10.1321 10.4555 6.53489 -7.45039 0.329373 10.0784 -632 2 10.6046 9.83719 7.10845 -0.190248 -0.487921 -4.0191 -633 2 10.6634 10.5725 5.74842 5.176 -1.34798 -7.09506 -634 1 6.75471 15.7115 6.57125 -11.9312 -6.35937 -2.57899 -635 2 7.17812 16.0056 7.37746 4.55156 8.98271 2.0062 -636 2 6.84858 16.4009 5.89838 10.4548 -3.40393 4.92981 -637 1 6.44667 13.1112 5.62964 2.65073 6.32881 3.74437 -638 2 6.67596 13.9769 6.00675 -0.0120675 -6.80172 -3.34498 -639 2 5.96115 12.6448 6.31389 0.45756 -2.92263 2.45964 -640 1 16.7937 12.5442 9.80018 5.98989 11.7335 -8.95445 -641 2 16.9887 11.9765 9.05284 -0.702856 -11.4944 -2.64553 -642 2 17.0098 13.4184 9.45025 -4.64512 -2.35242 9.41775 -643 1 6.08081 2.94855 2.81201 5.81343 6.87552 13.2918 -644 2 6.21399 3.88965 2.59312 -1.02666 -12.0092 -4.68113 -645 2 5.77459 2.45978 2.03916 -1.91968 5.61369 -5.09877 -646 1 10.8797 3.26448 3.27711 -5.41025 -2.45564 -6.20574 -647 2 10.301 3.99846 3.49319 -0.0844139 2.78359 4.78679 -648 2 10.5123 2.93026 2.45079 3.61554 -5.12824 0.569032 -ITEM: TIMESTEP -40 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.73557 7.01799 17.9607 21.964 -6.69295 -3.41675 -2 2 7.837 6.97936 18.244 -22.923 1.28376 8.03757 -3 2 8.84363 6.25859 17.3828 1.27689 0.0651665 -4.69765 -4 1 18.6647 8.30209 6.83035 -0.644058 3.99523 -48.5507 -5 2 0.211245 8.12789 5.86514 -9.60619 8.91963 25.083 -6 2 0.465598 7.58914 7.26037 9.90688 -14.2806 22.1152 -7 1 8.44495 18.6364 6.8238 -19.0399 -0.344231 6.51496 -8 2 9.34052 0.200584 6.61788 21.6732 5.78047 -4.99449 -9 2 7.92466 0.711623 6.44684 1.16681 0.183702 -1.11302 -10 1 6.56005 1.80411 11.6838 -38.7214 4.43655 14.793 -11 2 5.75321 2.272 12.0538 30.5925 -16.6996 -9.96133 -12 2 6.22943 0.898268 11.5156 6.32845 11.0599 0.0206858 -13 1 7.08366 5.68816 2.38617 22.7225 -30.9477 -12.475 -14 2 6.58152 6.21056 2.95839 -27.8787 23.1579 37.4024 -15 2 6.84697 6.04683 1.54845 0.038941 9.08719 -25.9535 -16 1 16.22 10.2137 16.0864 41.4588 -5.13522 6.23048 -17 2 17.1921 10.3703 16.208 -28.8473 -8.8876 -9.54756 -18 2 15.8271 11.0171 16.4051 -13.971 12.6367 2.51598 -19 1 10.6448 14.9575 2.33364 6.27542 19.2207 -0.856148 -20 2 10.5562 14.6084 3.22703 2.40752 -4.54155 -3.02292 -21 2 11.1101 15.8129 2.46012 -8.85901 -18.4002 -3.84051 -22 1 17.1611 8.2532 10.553 -11.2529 -0.0170881 12.6501 -23 2 16.8393 8.94572 11.1538 -1.12797 -5.57792 -5.31501 -24 2 17.9446 8.61302 10.1436 10.8511 4.56282 -2.94704 -25 1 14.7728 15.897 16.3892 -19.7826 14.9663 0.46496 -26 2 13.8411 16.2137 16.4626 21.4068 -5.53606 -7.5515 -27 2 14.9622 15.5552 17.2653 -0.403084 -10.0705 4.87845 -28 1 12.136 13.4022 0.475357 -11.3959 -2.02194 -12.751 -29 2 11.9408 13.3873 18.1673 8.9331 -2.53085 4.8524 -30 2 11.4037 13.9022 0.849725 6.62825 2.84238 11.8203 -31 1 9.29338 5.44787 4.01163 24.6694 12.616 -29.9837 -32 2 8.80858 5.1972 4.76287 -21.098 -14.9153 34.0625 -33 2 8.63435 5.49966 3.31701 -4.42724 -1.21089 -8.36553 -34 1 1.79376 4.18976 11.6282 4.46954 -46.7602 7.51249 -35 2 1.70048 5.09501 11.8512 -4.37305 32.1952 10.6933 -36 2 2.09275 3.70286 12.4334 -4.9207 12.4729 -20.4441 -37 1 2.01732 6.80615 8.34226 1.64844 10.8358 -0.647304 -38 2 2.37448 7.3471 9.0762 -2.77819 -13.6149 -8.9692 -39 2 1.92609 5.89421 8.65385 1.80745 6.26657 1.98394 -40 1 5.38901 4.42498 7.95307 14.0474 9.0477 19.097 -41 2 5.49608 3.48465 7.79451 -4.39314 -7.26091 -3.25333 -42 2 4.79389 4.80722 7.31869 -10.598 0.276841 -18.5158 -43 1 3.29732 2.94293 17.5086 17.2208 -30.0882 -17.6092 -44 2 4.02601 3.30007 16.978 -4.8938 2.423 1.99348 -45 2 2.81217 3.66256 17.8655 -12.7512 26.7583 13.4218 -46 1 7.44366 5.31542 6.10005 -2.04578 -15.3999 -38.6663 -47 2 8.07874 5.97061 6.33436 13.5587 20.8049 21.0336 -48 2 6.95124 5.08125 6.86821 -11.582 -6.53412 22.3247 -49 1 9.78574 7.01841 12.0035 -14.224 -5.31732 -23.9819 -50 2 10.3573 6.41663 11.5027 -2.93892 5.75769 9.08141 -51 2 9.02058 7.16943 11.392 19.9248 1.87014 17.2782 -52 1 14.0222 3.60384 8.07347 21.1656 -3.6634 36.3987 -53 2 13.9951 4.24089 7.37961 -2.65045 17.7741 -13.562 -54 2 14.5465 4.02482 8.8088 -19.0215 -13.1146 -21.9867 -55 1 4.60432 17.1743 3.97092 -4.17058 -8.50894 9.4345 -56 2 5.51528 17.3741 4.10719 24.7317 1.00316 8.45766 -57 2 4.31895 17.8257 3.35422 -16.1123 9.67587 -20.1592 -58 1 16.4938 16.6102 10.1803 -22.58 10.2442 28.8776 -59 2 15.6971 16.8258 10.7464 27.0105 -10.9286 -19.8859 -60 2 16.1827 15.9878 9.51957 -5.57273 -0.00226425 -4.98818 -61 1 1.9645 4.84741 0.368078 -14.0488 -12.8308 -13.2388 -62 2 2.69854 5.15593 0.879033 14.2396 9.43314 15.7095 -63 2 1.5724 5.64147 0.000503254 -0.0595591 4.00938 -5.12573 -64 1 11.6747 13.3071 16.3147 -7.05005 22.2307 18.0491 -65 2 11.0866 12.5598 16.3919 -3.1788 -17.5748 -3.92498 -66 2 12.2584 13.1709 15.5748 2.75178 -8.36686 -13.1919 -67 1 10.131 11.038 16.8986 -21.0542 26.9507 -1.58256 -68 2 10.4848 10.1706 16.8573 15.2828 -28.4038 0.505132 -69 2 9.17797 10.924 16.7712 4.48065 0.743861 -0.190366 -70 1 11.7352 17.4666 13.4614 -1.07936 25.6776 8.56908 -71 2 12.4835 17.2209 12.9203 3.02318 -9.35187 -8.63799 -72 2 11.8077 18.4454 13.5145 -0.798306 -16.7366 -1.43427 -73 1 6.39395 9.3313 12.2301 16.0138 21.1557 17.835 -74 2 6.78657 8.92292 11.474 4.59605 -10.3711 -18.9433 -75 2 7.12055 9.89522 12.5742 -21.4515 -7.31443 1.84288 -76 1 16.2436 12.8045 2.69297 9.19112 6.28957 -1.09055 -77 2 17.1119 13.1995 2.45018 -21.0084 -1.00278 4.98407 -78 2 15.5746 13.5129 2.79044 13.212 -4.74068 -2.98151 -79 1 0.66547 12.6008 5.89246 44.3801 0.278469 12.8923 -80 2 0.944588 12.4662 4.9918 4.15776 -1.70344 -11.3497 -81 2 18.3844 12.6561 5.85431 -44.3715 7.63264 -5.03051 -82 1 5.23201 16.4301 18.4413 -23.1671 11.3407 -2.74477 -83 2 5.81563 15.7669 18.0873 14.8521 -9.88299 1.40517 -84 2 5.51268 16.7513 0.656182 8.57816 -5.72834 2.04059 -85 1 0.568352 7.66823 4.13077 -28.9792 -20.0076 22.3714 -86 2 18.6051 8.03762 3.49503 -7.9612 4.34402 -11.87 -87 2 1.4037 8.01472 3.91532 39.463 15.435 -13.2826 -88 1 3.11888 8.95318 6.49662 60.4725 2.42495 -6.82714 -89 2 3.7308 8.46704 7.08062 -7.96075 9.2896 -8.18079 -90 2 2.27986 8.68504 6.76207 -50.4171 -10.8396 15.4956 -91 1 7.30368 10.3509 16.2473 20.2996 0.0228567 -17.1566 -92 2 6.66358 10.504 15.5564 -7.99994 0.888183 -0.524161 -93 2 6.82737 10.217 17.0566 -12.2765 1.21271 14.6854 -94 1 11.12 1.01485 5.00375 -0.0102216 2.84952 14.1843 -95 2 11.0857 1.87302 4.56078 2.3673 -3.0702 -4.20032 -96 2 10.7324 0.367128 4.41621 -3.73217 -2.39612 -13.1961 -97 1 4.37027 2.7904 13.2033 3.18584 17.5115 -8.99997 -98 2 4.79356 3.08499 14.0007 6.25053 15.0735 9.59097 -99 2 4.18046 1.89747 13.4272 -8.57413 -32.1756 -2.785 -100 1 8.40183 10.1302 1.81819 -11.3119 21.1596 -20.1509 -101 2 8.22596 10.8234 2.46526 3.55036 0.443395 1.34914 -102 2 8.74004 9.40086 2.30376 11.7587 -22.7948 15.5041 -103 1 10.4641 1.71908 15.5611 14.2583 -4.22402 3.33599 -104 2 11.4066 1.52258 15.371 -17.8532 5.60176 1.9802 -105 2 10.08 2.13518 14.7824 5.57904 -1.0897 -7.54918 -106 1 2.70316 12.9014 7.80195 3.19617 10.9991 1.8073 -107 2 3.3212 13.5754 7.49282 0.460726 -0.40643 1.73206 -108 2 2.13336 12.7538 7.04495 -5.07282 -6.75217 -1.11681 -109 1 3.70861 11.6625 5.14703 20.6482 18.5599 0.117703 -110 2 3.55555 10.8287 5.56068 -6.18613 -18.2271 10.4705 -111 2 3.04771 11.7826 4.47739 -15.5561 1.61657 -8.41129 -112 1 6.75631 14.4548 16.9127 8.94674 -1.78931 -0.924301 -113 2 7.71443 14.3361 16.9267 -6.94418 4.38523 0.882829 -114 2 6.52635 14.6721 16.0018 -2.96874 0.297136 0.835917 -115 1 14.1768 14.5549 3.37546 -9.20747 -5.25648 5.53536 -116 2 13.5738 15.2994 3.18581 6.88801 -12.7747 3.05988 -117 2 13.7349 13.9262 3.9882 4.46288 16.3838 -11.0193 -118 1 8.36945 18.1316 16.043 -50.6417 14.5597 -0.377943 -119 2 8.83326 17.39 16.374 32.1095 -21.5179 4.54953 -120 2 8.87194 0.178112 15.6264 24.4627 6.71878 1.23367 -121 1 4.74402 1.66109 4.92978 -19.7446 -31.5867 36.4561 -122 2 3.83516 1.95374 4.92736 -8.28526 7.01041 1.88485 -123 2 5.14187 2.10852 4.23181 25.7722 28.9669 -41.4039 -124 1 15.0327 12.6922 16.4463 -14.1895 -13.4373 -36.9651 -125 2 14.5853 13.1594 17.1179 -4.44761 17.5587 33.5367 -126 2 14.3173 12.6168 15.7704 28.0544 -5.79477 6.54775 -127 1 15.7455 18.4472 16.8494 -36.7721 -17.2537 -45.0168 -128 2 16.3082 18.5742 17.5575 42.6678 12.9246 46.9817 -129 2 15.6033 17.4929 16.845 -6.46687 1.33922 -4.84851 -130 1 1.19925 1.17644 16.5482 3.81725 -14.252 -17.647 -131 2 1.9494 1.76296 16.5282 11.9166 8.08174 5.38627 -132 2 0.720072 1.41993 17.3243 -10.8728 8.87917 17.8692 -133 1 18.1194 4.51517 15.8978 -9.12682 11.3324 16.5545 -134 2 18.3907 3.99589 15.1624 6.35448 -14.0345 -18.3092 -135 2 0.212938 4.54105 16.5062 3.72114 1.23331 1.72655 -136 1 12.2575 16.9791 16.1441 20.307 19.4582 -44.4732 -137 2 11.5756 16.5974 16.6415 -35.2707 -20.5418 23.5889 -138 2 11.9443 16.955 15.2053 9.79722 2.45701 21.3583 -139 1 15.9948 2.53341 18.0767 10.9381 -15.7258 5.9061 -140 2 15.4972 3.23449 18.4655 -6.78731 22.0319 12.1926 -141 2 15.8185 2.63494 17.1497 -1.81081 -2.22204 -19.1287 -142 1 6.71322 13.8205 10.2184 4.21251 -0.72826 -19.8354 -143 2 6.51318 13.5527 11.1172 -1.15071 -8.01371 4.0626 -144 2 6.63912 13.0526 9.6212 -3.83744 4.98216 12.3358 -145 1 10.1462 18.2988 2.74675 -22.097 -20.0437 20.6404 -146 2 10.3757 0.350258 2.15404 6.85623 19.4082 -18.4799 -147 2 9.18692 18.1396 2.61143 20.6475 -0.265938 -2.33946 -148 1 3.01179 17.7216 6.11391 16.3646 11.1083 -7.5066 -149 2 2.20644 17.7129 5.60578 -13.7656 -5.82691 -3.27397 -150 2 3.67703 17.9821 5.44947 -4.29715 -10.1951 11.4126 -151 1 12.5763 16.9057 8.00279 34.6812 6.34788 -19.799 -152 2 11.842 16.3339 7.82778 -18.535 -10.6459 7.52248 -153 2 12.4277 17.4882 8.74445 -13.6741 4.98834 7.73701 -154 1 14.8867 15.2801 8.21669 15.2681 -20.6133 -0.236719 -155 2 14.2473 15.9935 8.15265 -4.83203 2.49296 -8.82369 -156 2 15.4177 15.201 7.39136 -14.8487 16.0275 12.7595 -157 1 17.673 18.2386 0.358056 6.39969 9.72416 1.64776 -158 2 18.5627 17.8182 0.243387 -17.6184 17.4743 1.20562 -159 2 17.7074 0.56338 0.562155 11.394 -25.7036 -4.78753 -160 1 0.840605 10.4115 1.35744 37.4959 50.4012 -24.017 -161 2 0.0672579 9.99096 1.64345 -42.7842 -22.4511 10.6341 -162 2 0.58692 11.2092 0.808654 3.76922 -28.1369 19.051 -163 1 1.6843 12.2358 3.38047 -6.18426 -19.2714 -7.57792 -164 2 1.35621 11.4726 2.83119 9.65923 28.3457 4.48748 -165 2 1.68469 13.0653 2.87986 -2.69674 -10.3555 -4.68476 -166 1 0.583101 17.235 4.89274 4.80321 -10.1773 15.6529 -167 2 18.7212 18.0548 4.74777 -0.344371 -10.7938 17.6071 -168 2 0.457865 16.8228 5.79389 -3.26711 20.5272 -26.9728 -169 1 1.10197 0.931397 9.43269 -15.4399 -19.3078 -9.02275 -170 2 1.25908 0.443364 10.2575 0.781623 10.2528 -2.87546 -171 2 0.281175 0.525265 9.08113 16.3171 12.9297 7.39947 -172 1 16.7532 2.33623 13.2905 -6.48112 -9.83965 38.5991 -173 2 16.8955 2.59135 12.4052 6.16672 6.51778 -37.0535 -174 2 16.4416 1.41783 13.3009 4.47832 4.66932 -0.969858 -175 1 2.60624 15.8504 12.1681 -27.4943 19.2901 -21.9402 -176 2 3.16839 15.391 12.7532 19.3125 -15.6847 20.968 -177 2 2.92961 15.6774 11.278 4.5792 -4.36857 -3.32021 -178 1 16.4212 15.6424 6.03078 2.33398 -27.7044 12.4884 -179 2 17.3276 15.7008 6.32 9.77501 -6.8374 8.24343 -180 2 16.3266 16.4053 5.49767 -10.7497 25.3256 -21.0495 -181 1 5.80196 5.07502 11.792 -7.0375 5.38003 9.08436 -182 2 5.27256 5.62589 12.4097 12.9595 -6.51078 -10.685 -183 2 5.4277 4.18781 11.8485 -2.70068 5.27459 0.5345 -184 1 15.1729 4.86274 0.750774 -1.10571 10.9128 -33.6343 -185 2 15.2042 4.59535 1.64712 -4.27265 -9.78555 34.3171 -186 2 14.3466 5.34824 0.643665 4.19718 -3.49047 -1.12139 -187 1 16.3347 16.3636 2.07743 2.17372 -8.94604 27.567 -188 2 16.248 16.684 3.01162 -4.2135 -4.93901 -27.3972 -189 2 16.5997 17.1143 1.55727 4.53602 12.7734 -5.95158 -190 1 0.261441 4.84804 3.8055 -0.147017 -56.3045 13.8461 -191 2 0.475233 5.74211 3.84367 9.07909 56.4423 -0.745388 -192 2 0.927869 4.41838 4.37361 -9.48651 2.83213 -9.85838 -193 1 2.95802 15.0603 15.1014 -0.943114 0.172839 -27.3629 -194 2 2.80338 14.7297 15.9709 -3.98201 -9.31011 23.138 -195 2 2.36314 15.8122 15.0164 6.10514 4.60789 3.27938 -196 1 1.13815 14.652 9.54287 -29.9359 -26.3887 42.7894 -197 2 1.85794 14.2975 9.07203 33.137 -5.88851 -26.0645 -198 2 1.02375 13.9289 10.2175 -6.6715 26.0405 -18.8729 -199 1 13.5762 16.6063 11.5459 8.2131 -23.6119 0.793767 -200 2 13.33 17.296 10.9485 -9.11427 22.0857 -7.2987 -201 2 13.1805 15.8285 11.1175 -0.169415 1.89227 9.19008 -202 1 4.67714 1.46335 0.758621 16.4224 4.90719 -8.19047 -203 2 4.16601 2.0159 0.158762 -4.20381 1.9839 -0.0593356 -204 2 4.09672 0.7797 1.07984 -10.7002 -7.55851 6.47825 -205 1 1.4518 18.552 11.8572 6.2605 -28.7314 5.6203 -206 2 1.30143 0.363179 12.6934 -0.382356 1.32639 0.00372943 -207 2 1.68394 17.6168 12.0771 -1.80479 24.861 -1.36748 -208 1 11.5075 10.1198 4.02095 -18.4811 -8.70186 23.5865 -209 2 11.1917 10.5684 3.24759 -2.79925 6.67004 -19.1711 -210 2 12.4478 10.2129 4.02159 23.6747 0.339266 0.782627 -211 1 8.31226 12.1774 3.6909 13.3967 -8.0925 -50.6166 -212 2 9.08853 12.6634 3.95409 8.19758 6.83683 10.985 -213 2 7.73108 12.1161 4.40989 -25.5486 3.81511 42.2514 -214 1 14.4234 4.01167 3.27932 -6.39999 -0.808874 -15.5703 -215 2 15.0318 4.04602 4.01015 9.81333 2.6424 13.2185 -216 2 13.6949 4.61166 3.47516 -0.628596 -1.04819 4.76047 -217 1 5.60276 1.68001 7.51543 46.6974 51.3536 -38.165 -218 2 4.99884 1.09753 7.87161 -47.5789 -43.021 28.4342 -219 2 5.32972 1.80197 6.58421 6.01087 -7.11276 10.7862 -220 1 17.8847 1.08156 4.86879 -16.2479 -18.084 1.95698 -221 2 18.6198 1.37964 4.35055 14.6356 14.0949 -7.48199 -222 2 17.763 1.66674 5.61639 2.20316 6.60999 2.39214 -223 1 6.81142 9.41573 4.49306 -0.655622 0.432156 7.98772 -224 2 6.876 9.60924 5.45033 2.30801 -5.82211 -14.8304 -225 2 7.69814 9.2085 4.16641 0.21776 -0.211816 8.23149 -226 1 2.64622 14.9044 1.97705 -19.6169 -6.34757 32.4999 -227 2 3.24366 14.6749 2.7111 -2.05224 3.38495 -12.0409 -228 2 3.14951 14.9574 1.1885 18.3224 0.185563 -21.7099 -229 1 17.3026 12.9105 13.1506 5.97988 10.8617 -4.35729 -230 2 16.4943 13.3715 13.3508 -17.5214 -4.76439 4.13034 -231 2 17.8495 13.6655 12.9025 6.83053 -7.65676 -2.15198 -232 1 14.953 10.5544 1.38215 35.2581 29.1908 17.9973 -233 2 15.5812 11.2612 1.74238 -25.4064 -29.0048 -15.0024 -234 2 14.0938 10.9575 1.42777 -9.92862 1.12257 -1.65093 -235 1 5.7132 6.77849 4.57909 1.57168 19.8101 -12.7812 -236 2 6.1646 7.64962 4.62346 -11.1008 -12.4177 -0.29751 -237 2 6.30742 6.13992 4.97063 6.93571 -3.41618 11.3539 -238 1 8.02607 8.31482 10.3199 -6.67367 -6.11991 -5.1902 -239 2 8.5826 9.1064 10.2496 0.567217 -7.04018 -13.4516 -240 2 7.81744 7.96553 9.42928 8.80325 8.4252 13.4279 -241 1 13.463 18.3942 5.75922 18.2094 9.72717 -25.7917 -242 2 12.7029 0.253225 5.44631 -3.25776 3.56949 4.30859 -243 2 13.1448 17.7819 6.40042 -11.4028 -12.4364 22.7676 -244 1 0.157572 2.62906 0.18715 -8.27583 -44.4001 -2.30616 -245 2 17.9404 2.90438 -0.139246 -4.84787 10.7772 1.25282 -246 2 0.728557 3.33866 0.428035 8.4047 29.5908 2.16632 -247 1 12.7834 11.0467 9.74512 50.2143 -37.9981 33.2215 -248 2 11.9361 11.0491 9.39224 -54.8114 3.18277 -19.015 -249 2 12.8684 10.1188 10.1004 3.84712 25.3375 -10.5627 -250 1 0.745434 12.1889 11.0782 -25.5268 2.00553 -1.18025 -251 2 18.4134 12.2219 11.1204 10.6569 -0.780029 -7.62666 -252 2 1.00048 12.4147 11.9671 12.4315 1.99225 10.3147 -253 1 5.08453 7.29937 13.4403 2.24753 -3.99956 1.86213 -254 2 5.64891 7.85147 12.8757 -3.98378 2.58677 10.115 -255 2 5.52437 7.26557 14.3066 0.821915 -2.02828 -9.69703 -256 1 1.22699 6.88005 11.8698 42.6355 29.3241 27.8417 -257 2 0.513102 7.24659 11.3736 -15.3023 8.70694 -9.89945 -258 2 1.76616 7.68013 12.1994 -27.3906 -36.7234 -16.475 -259 1 15.5048 9.56381 12.3059 14.0365 -21.5239 -8.17825 -260 2 15.0446 10.3738 12.2505 -11.2614 35.3449 -7.27588 -261 2 15.2981 9.243 13.1696 0.51668 -8.53923 17.0206 -262 1 16.6213 12.8097 5.50479 11.7533 -20.9364 35.7876 -263 2 16.4281 13.7341 5.58129 -4.58024 20.9264 -6.48074 -264 2 16.496 12.5383 4.61195 -7.15835 1.38375 -28.6034 -265 1 6.25272 9.92074 0.051253 25.5558 -5.2213 19.2814 -266 2 5.65499 10.4134 0.617489 -6.63873 2.74854 -0.55683 -267 2 7.09279 9.88715 0.575545 -19.794 1.5448 -11.6918 -268 1 12.3217 6.11544 4.06855 24.0308 27.0278 -26.8963 -269 2 12.2667 6.69224 3.25542 -0.750296 -12.6773 27.7542 -270 2 11.603 5.51542 4.01585 -23.4349 -14.6267 -3.11795 -271 1 0.228308 12.8043 0.188232 11.1572 0.898125 2.61316 -272 2 0.191448 13.5221 0.829575 -7.01271 0.62324 2.49922 -273 2 18.423 13.1312 18.0517 -4.48315 2.42872 -7.20237 -274 1 3.7281 18.597 8.57641 -7.3642 13.4464 17.6561 -275 2 3.55952 18.0214 7.8301 -5.82536 1.28732 -6.71467 -276 2 2.87154 0.379366 8.79158 11.2944 -8.20129 -4.53508 -277 1 7.45075 17.3023 4.47746 -12.4687 -31.8552 -5.62811 -278 2 7.62794 18.1881 4.68695 9.53175 40.2972 16.7849 -279 2 7.50734 17.3052 3.52795 -1.99738 -6.99443 -12.8094 -280 1 9.24058 17.0897 12.2501 -24.9009 9.53262 -6.54721 -281 2 9.25026 16.4035 11.594 -4.50925 -12.7792 -11.7902 -282 2 10.1098 17.0766 12.5981 28.7243 3.47903 16.8433 -283 1 13.2876 12.9366 7.99409 13.1339 47.0026 -12.7195 -284 2 13.3658 12.2269 8.61754 6.78146 -9.97429 11.7811 -285 2 13.946 13.6564 8.215 -16.5737 -23.9385 -2.8436 -286 1 14.9278 2.97205 15.3542 -22.0243 3.95222 27.314 -287 2 14.2978 2.24466 15.255 3.92553 0.418625 -2.59085 -288 2 15.495 2.9795 14.6023 14.212 -3.72656 -21.152 -289 1 9.88733 15.5502 16.9939 -6.96656 2.06857 9.21519 -290 2 10.3024 14.7219 16.7214 3.24805 0.519307 1.1538 -291 2 9.47388 15.4159 17.8681 4.17307 -0.448199 -10.2742 -292 1 11.3272 8.33778 16.5655 -12.1447 -4.13113 3.07889 -293 2 10.5941 7.97459 16.029 11.4521 -0.447246 11.036 -294 2 11.3675 7.80686 17.3849 -1.98947 6.30133 -12.9317 -295 1 3.91087 18.2078 16.7523 8.10648 -24.8729 2.7978 -296 2 4.29329 17.4751 17.2712 -2.30537 5.45923 -13.1249 -297 2 3.83261 0.235403 17.405 -4.96911 23.3333 9.68201 -298 1 2.20524 4.16671 8.93127 -30.922 4.24465 -33.9389 -299 2 3.10409 4.18899 8.66341 29.7515 -2.18627 -0.590115 -300 2 2.16419 4.10976 9.8632 4.73941 -5.36165 36.7803 -301 1 9.8752 10.3748 9.71669 16.1383 -34.8575 15.3318 -302 2 9.43878 11.1114 9.34267 -12.9257 32.2344 -10.6144 -303 2 10.0704 10.5459 10.6459 0.567735 2.49547 1.17829 -304 1 9.70603 0.859612 10.8594 11.2219 3.05072 8.41213 -305 2 9.26848 0.0594607 11.2011 -2.07101 7.3453 -10.3505 -306 2 9.18365 1.30902 10.1791 -6.8322 -10.1071 2.86508 -307 1 9.20299 15.1273 10.2305 31.122 11.5717 5.63223 -308 2 8.76871 15.6899 9.60445 -9.85228 15.7354 -8.32779 -309 2 8.63472 14.3875 10.3233 -23.0991 -20.0884 3.25194 -310 1 0.96837 9.47951 10.2963 -70.5876 8.50765 14.6853 -311 2 0.835229 10.4182 10.5095 11.9906 -6.34251 -2.52384 -312 2 1.84768 9.33537 10.0919 56.817 -0.102153 -14.2985 -313 1 16.9556 4.85371 8.1764 15.2186 15.5475 -39.5257 -314 2 16.4324 5.61135 8.41217 -10.5813 9.18021 7.17639 -315 2 16.8473 4.22258 8.84986 -2.43363 -23.5078 29.961 -316 1 14.6968 14.7113 0.249291 21.1749 6.84176 -19.9636 -317 2 15.2416 15.0749 0.948116 1.7369 4.80193 6.96981 -318 2 13.9408 14.343 0.670519 -22.6431 -9.26918 11.3127 -319 1 3.62773 11.0513 9.55661 13.6415 -11.4582 11.5887 -320 2 3.64622 11.3868 10.4653 -1.2087 2.23818 -2.33891 -321 2 3.18854 11.7052 9.01978 -9.00441 8.94912 -6.83793 -322 1 11.1486 10.7845 1.39435 -11.9859 -27.9615 14.113 -323 2 11.4982 11.6036 1.1014 8.88176 28.2378 -14.4203 -324 2 10.2242 10.7355 1.11217 4.88573 2.00485 1.40976 -325 1 13.1617 7.12114 12.7848 27.9985 9.25187 0.204961 -326 2 14.1485 7.05909 12.8492 -22.0105 -1.86773 -1.16605 -327 2 12.8387 6.22307 12.8528 -4.13181 -6.51108 -0.646654 -328 1 9.62686 1.89618 0.979059 -11.1933 -2.25437 -17.4068 -329 2 8.86583 1.44793 0.536192 15.085 16.0595 8.12302 -330 2 10.1008 2.43338 0.313674 -4.24921 -13.4265 6.88026 -331 1 10.6169 13.5248 4.60784 -18.2432 -3.19473 -12.9411 -332 2 11.3551 12.9251 4.5569 15.1862 -3.85234 3.34493 -333 2 10.6581 13.9134 5.47279 3.49634 8.81883 14.723 -334 1 14.3649 1.74425 10.9305 5.54735 -12.1033 0.31392 -335 2 15.2006 1.47853 10.5325 -1.1471 -9.04293 -1.43649 -336 2 14.4646 2.6903 10.9924 -3.65076 12.6994 -0.169483 -337 1 14.6084 12.2765 11.688 7.48969 -0.0414248 52.7612 -338 2 15.3889 12.4412 11.1797 12.3837 0.874018 -20.9659 -339 2 13.8613 12.0797 11.1652 -22.2598 -6.69151 -32.5036 -340 1 8.22131 5.06515 9.81151 31.4859 -23.4564 -24.7693 -341 2 7.50576 5.35441 10.3398 -29.672 2.17434 15.6894 -342 2 8.09879 4.11038 9.58602 -2.47918 22.6636 6.16193 -343 1 1.53723 16.856 18.3772 -4.91865 -38.0309 19.5229 -344 2 1.81973 17.2424 17.568 8.52952 11.4507 -22.0862 -345 2 1.68062 15.8825 18.2332 -2.55663 27.9439 5.8223 -346 1 1.48989 17.248 15.3251 -39.2991 7.69546 7.77355 -347 2 1.63979 18.1273 15.7491 -10.9611 -20.0854 -9.27397 -348 2 0.505086 16.9983 15.3475 43.8724 16.6347 0.193712 -349 1 3.67894 5.68848 6.10927 6.21387 -9.44646 -9.55971 -350 2 3.15123 6.21186 6.69497 -13.0277 9.84767 14.8728 -351 2 4.18038 6.32117 5.58457 4.58642 -2.3545 -2.10993 -352 1 12.397 9.46521 14.1943 -11.4291 42.6821 2.6577 -353 2 12.6884 8.68898 13.7764 17.0449 -39.3969 -17.6043 -354 2 12.207 9.20402 15.087 -1.24705 -6.16332 16.3323 -355 1 4.0418 15.2774 6.91931 -38.8927 -2.71008 6.44315 -356 2 3.58633 16.0735 6.61178 -2.62598 -4.70343 -0.502904 -357 2 4.94439 15.4914 6.84844 41.7142 6.1892 -4.79175 -358 1 0.605801 8.58372 14.9539 0.254512 0.326548 7.88367 -359 2 0.527439 9.52499 15.1145 -2.4036 7.40824 2.35469 -360 2 1.30759 8.52231 14.3126 8.3049 -1.83762 -9.50966 -361 1 12.9717 8.29262 10.2927 -22.7594 16.3387 10.1639 -362 2 13.6731 7.84025 9.84078 14.5836 -10.6745 -2.92467 -363 2 13.0109 8.02582 11.2281 0.923047 -2.44701 -11.6389 -364 1 15.3232 7.71175 3.53457 4.84131 -0.438878 0.085747 -365 2 14.6048 7.2242 3.18847 -27.3478 1.70601 -26.568 -366 2 15.5504 7.10949 4.22607 20.3905 5.82918 25.2924 -367 1 17.3123 6.68101 0.0543458 25.2448 -11.5383 1.06581 -368 2 16.8643 5.84811 0.208139 -4.52976 -2.78536 3.6701 -369 2 16.6324 7.27442 18.4294 -24.004 18.1506 -8.07094 -370 1 8.88314 6.92259 7.79709 31.0126 27.4325 -12.7619 -371 2 9.82162 7.25311 7.83141 -27.6614 -7.83044 -3.12143 -372 2 8.85418 6.18364 8.38751 -5.1761 -15.9168 16.933 -373 1 12.3742 0.616612 1.23426 0.620177 6.71182 8.7173 -374 2 13.3152 0.448787 1.38768 -5.31542 -0.309906 -0.296651 -375 2 12.0908 0.227811 0.410291 5.35555 -3.35826 -6.33914 -376 1 5.63073 15.1419 14.5354 -14.6404 -24.282 5.65856 -377 2 4.69276 15.2374 14.754 2.80482 -4.42056 0.607876 -378 2 5.89918 16.0006 14.2671 15.2941 25.5531 -11.1631 -379 1 3.85325 6.46699 1.73385 7.01958 -17.0097 2.38606 -380 2 3.51461 7.31896 1.46783 -8.17546 12.9796 -1.79528 -381 2 4.05434 6.54403 2.67764 -3.63249 4.46552 -6.11981 -382 1 3.88854 11.6061 12.3354 -12.5844 1.40703 6.82309 -383 2 4.76337 11.9285 12.5525 8.64878 0.03141 -1.44708 -384 2 3.2838 12.173 12.8501 6.64476 -9.03704 -9.92286 -385 1 5.37483 3.86954 15.8708 7.06931 -74.8011 -5.77053 -386 2 6.14587 3.26348 15.6611 -29.2279 19.2574 6.80998 -387 2 5.70286 4.72315 15.8147 21.5682 55.4234 -2.96121 -388 1 14.3763 10.2794 4.46201 -32.4101 28.4329 49.0365 -389 2 14.443 9.83621 5.32683 0.971611 4.81404 -7.53945 -390 2 14.839 9.74155 3.87936 25.2894 -34.3452 -37.3821 -391 1 7.80918 17.3929 9.15872 22.1479 -28.1908 5.37522 -392 2 6.96403 17.5587 9.551 -17.6194 9.20761 3.63927 -393 2 7.9906 17.9725 8.42371 -6.45863 11.4679 -7.92664 -394 1 4.50911 14.4925 3.93603 -3.72296 -18.8397 -53.7951 -395 2 4.39275 15.3834 4.18687 0.185157 34.2159 14.5975 -396 2 4.6886 13.9787 4.68865 6.61933 -20.0316 37.8242 -397 1 14.2759 7.39669 15.8018 -25.3443 -8.35453 -18.4147 -398 2 15.2098 7.32722 15.7472 31.3188 -3.09541 -3.64929 -399 2 14.1076 7.77613 16.6483 -2.08075 9.82337 20.7866 -400 1 2.98131 18.2876 1.92072 -8.89863 -34.7534 -28.0783 -401 2 2.43865 17.6277 1.38436 23.5626 24.7731 19.3405 -402 2 2.37413 0.302092 2.22775 -14.7638 14.2119 8.82016 -403 1 7.98427 1.62335 4.57287 -40.8947 -0.445207 11.16 -404 2 7.39585 2.15768 4.00383 13.1095 -6.60943 2.01257 -405 2 8.85324 1.63658 4.22836 26.1363 6.2526 -15.7033 -406 1 2.50726 14.1431 17.6951 16.6159 21.4268 -10.1577 -407 2 1.94925 13.5738 18.1946 -18.2656 -19.6261 9.9334 -408 2 3.40865 13.8863 17.9244 2.82527 -4.33175 1.96247 -409 1 0.811695 1.74837 13.8925 -21.7292 3.59652 4.70406 -410 2 0.795118 1.42008 14.8166 -3.87613 7.88135 -16.9479 -411 2 18.5211 1.96459 13.6307 25.6616 -9.0685 11.0917 -412 1 4.4852 18.6484 13.9168 -33.7534 10.3053 3.09674 -413 2 5.3921 18.406 13.9761 25.2496 -8.78408 2.09715 -414 2 4.08373 18.5038 14.7912 8.14506 -1.30426 -6.00867 -415 1 7.12802 0.652367 18.3595 35.0739 -19.2419 -26.0317 -416 2 7.40845 0.19154 17.5185 -9.63956 16.0629 26.4358 -417 2 6.18456 0.683953 18.3433 -21.3742 6.93569 3.25827 -418 1 16.0657 18.4123 14.0301 53.2891 7.60066 12.7833 -419 2 15.2177 18.2242 13.7261 -48.7282 -11.4797 -7.69178 -420 2 16.0808 18.482 14.9966 -9.66087 4.27341 -2.7923 -421 1 10.0672 4.54369 16.2573 46.2132 32.473 -7.3661 -422 2 10.9795 4.93172 16.0704 -30.9355 -10.7562 9.7222 -423 2 10.2805 3.63455 16.4071 -7.05314 -22.7581 -0.39686 -424 1 15.904 17.802 4.45553 44.7656 -19.4466 -14.3322 -425 2 16.4088 -0.0282793 4.41597 5.24747 5.32524 1.83839 -426 2 15.0633 18.045 4.74212 -51.1512 14.4852 15.4733 -427 1 6.99737 17.3998 13.7879 -47.9218 -2.31875 -13.0268 -428 2 7.40243 17.6398 14.5891 19.7576 8.98543 35.5766 -429 2 7.70074 17.2583 13.1843 23.2619 -4.97282 -20.0499 -430 1 13.2941 6.48376 6.64986 8.60711 15.0683 16.7306 -431 2 13.9993 7.1541 6.49159 -11.9149 -19.7057 -4.80273 -432 2 12.8211 6.29295 5.83939 3.46216 6.87198 -11.4398 -433 1 7.76205 2.3443 9.26472 15.7579 10.991 45.3998 -434 2 7.20759 2.25447 10.0765 8.01487 -1.94761 -18.5756 -435 2 7.26048 2.06297 8.52639 -23.6607 -10.4133 -22.8687 -436 1 15.1706 14.8583 13.6757 15.7984 -16.1031 1.44613 -437 2 15.0167 15.231 14.5413 -6.09806 3.71972 9.46304 -438 2 14.6225 15.2955 13.0407 -11.5903 11.1836 -9.13521 -439 1 9.36431 8.31687 3.74781 -9.55399 11.9025 -3.42765 -440 2 10.1518 8.60925 4.20014 9.2003 9.72282 -0.0746101 -441 2 9.3553 7.37835 3.87681 -0.285781 -17.995 1.20514 -442 1 17.7597 13.5616 16.4405 -12.156 -24.6438 9.82021 -443 2 16.8551 13.2283 16.3395 1.48334 1.58847 4.06975 -444 2 17.7289 14.3961 16.0037 5.37456 23.0458 -12.1714 -445 1 4.95841 10.6088 2.75519 -22.9294 18.7883 -14.1686 -446 2 5.66909 10.277 3.27928 16.3083 -8.75526 16.0734 -447 2 4.6114 11.3873 3.23357 6.81328 -15.8641 -4.024 -448 1 3.73362 8.35206 10.1813 3.02598 13.3252 -21.6654 -449 2 3.8939 9.27056 9.86724 -4.6548 -13.2191 9.23973 -450 2 3.49789 8.39898 11.1021 -0.178845 4.23779 13.7606 -451 1 16.0042 7.01418 6.13738 -12.6879 19.8807 -2.17242 -452 2 16.808 7.4479 6.40937 10.6213 6.47779 2.98579 -453 2 16.2019 6.09716 6.06821 5.44302 -25.895 -2.3467 -454 1 15.1221 7.07483 9.10103 -4.15707 -25.1338 32.4641 -455 2 15.7464 7.4872 9.69859 9.03801 3.43378 3.13104 -456 2 15.1481 7.58948 8.33098 1.37226 23.8896 -40.0507 -457 1 6.35284 13.0135 12.8052 -0.193314 -18.9728 -17.7547 -458 2 7.21044 12.6571 13.0708 -4.00291 0.344811 4.20755 -459 2 6.11805 13.741 13.3614 0.492624 18.505 17.8288 -460 1 12.1195 4.49733 13.0969 -26.0004 -21.5883 -29.3264 -461 2 12.1632 4.68913 14.0325 -4.53328 -3.39715 11.6105 -462 2 11.3073 3.93318 12.8667 31.5163 26.387 18.3053 -463 1 11.3554 8.17046 7.8728 -3.27026 2.45633 -4.65198 -464 2 12.0683 7.62612 7.54639 6.23155 -9.6048 -12.5756 -465 2 11.5676 8.24955 8.79484 1.17104 5.44951 18.1694 -466 1 17.1791 10.8374 7.47157 -22.685 17.097 10.0101 -467 2 17.8401 10.2117 7.26521 25.6893 -28.4186 -0.815308 -468 2 17.2004 11.4333 6.72646 -9.08817 8.64759 -4.95169 -469 1 5.26928 18.1244 11.0251 26.2987 0.0330793 2.18763 -470 2 4.69547 17.8637 11.7317 -9.61751 -4.26247 14.7568 -471 2 4.70076 18.4264 10.3375 -16.9 2.57743 -21.8459 -472 1 7.59635 17.5306 1.81531 -10.9531 4.1869 -25.2725 -473 2 7.77056 16.6988 1.31883 2.24077 21.8764 10.5056 -474 2 7.30155 18.2046 1.15131 11.3055 -17.5184 13.1347 -475 1 1.92843 12.8944 13.5862 -6.59595 -16.5477 -16.8116 -476 2 1.43666 12.2821 14.1316 -5.58333 -5.88714 5.06202 -477 2 2.04362 13.6601 14.1181 9.10211 24.5058 14.6097 -478 1 9.63922 6.76943 14.8194 -3.94612 -18.0692 3.52162 -479 2 9.76751 5.80583 15.0218 -0.27339 26.7602 -8.06829 -480 2 9.98245 6.98264 13.9392 -2.96138 -9.43899 0.82382 -481 1 15.2804 4.29771 10.7711 -7.29951 -1.41697 -0.334277 -482 2 16.1821 4.02615 11.0218 -9.71269 11.8498 1.69675 -483 2 14.9105 4.9568 11.3864 17.8049 -7.45406 -3.59162 -484 1 11.2365 6.16159 0.180514 3.71779 6.92115 0.875598 -485 2 11.3264 5.36714 18.3195 14.2335 -18.3801 -6.22284 -486 2 10.2946 6.26806 0.197414 -17.1549 12.9032 2.71424 -487 1 0.0669242 11.3685 15.0652 13.212 -6.85086 18.3683 -488 2 18.0421 11.4114 14.3938 -11.7915 7.94746 -16.0964 -489 2 -0.126536 12.1197 15.6445 1.80559 0.362507 -3.06694 -490 1 7.04679 9.22841 7.26069 23.2883 20.8536 -5.26127 -491 2 6.49897 8.58869 7.67863 -15.4435 -25.8158 9.46312 -492 2 7.95399 8.89143 7.34084 -8.97527 1.37154 -2.4384 -493 1 18.3457 15.377 12.3544 -10.4554 -0.385944 -2.00928 -494 2 0.632165 15.4053 12.1583 18.2501 2.20759 0.366712 -495 2 17.9344 15.8751 11.6412 -4.56296 -0.981709 -1.73702 -496 1 16.5292 4.37759 5.24858 18.1125 19.5767 -27.8403 -497 2 16.7661 4.20984 6.14013 0.307987 -10.9951 33.7785 -498 2 17.3779 4.70209 4.86684 -19.0742 -11.8317 -4.1687 -499 1 17.7267 3.12899 10.7335 -24.2941 -12.2101 -5.28174 -500 2 18.5902 3.43151 10.9823 20.7538 0.196381 3.18907 -501 2 17.7917 2.2294 10.3565 4.74658 11.2046 4.02468 -502 1 12.2912 0.000462328 10.1205 5.29277 -42.3116 -12.7781 -503 2 11.463 0.345322 10.3908 -30.9755 9.64408 8.62664 -504 2 12.8898 0.704281 10.2182 28.9402 34.0259 3.93413 -505 1 10.3772 9.78855 12.3993 -21.9688 -12.411 -17.7787 -506 2 11.0129 9.78765 13.1014 16.013 1.76066 13.7043 -507 2 10.1738 8.8461 12.2399 4.72709 11.7982 0.616329 -508 1 0.569471 2.8284 7.02034 6.04311 -30.2491 -2.51113 -509 2 0.820763 3.41522 7.71636 2.48105 19.4463 13.5049 -510 2 0.862153 1.97327 7.38155 -6.15059 8.48947 -7.95665 -511 1 0.371359 15.3036 6.90441 -15.8595 21.8666 50.0789 -512 2 0.449232 14.6844 7.65301 -0.190166 17.9034 -2.10351 -513 2 0.621967 14.7945 6.18679 16.5003 -37.2512 -48.0182 -514 1 17.0414 7.00877 15.2159 -22.6634 4.89001 -1.64325 -515 2 17.7376 7.6544 15.0563 8.01654 -6.9456 2.15019 -516 2 17.4056 6.16817 15.5101 9.28872 0.897926 -1.45041 -517 1 9.06316 12.4266 8.08985 69.8766 6.47542 -0.0200154 -518 2 9.44101 11.8026 7.43298 -17.7999 4.13897 6.91255 -519 2 8.14431 12.4062 8.1331 -54.6706 -8.19385 -9.80298 -520 1 1.26891 1.85581 2.9921 11.7044 -8.67905 12.4997 -521 2 0.561231 2.0509 2.38915 -6.84046 11.4219 -12.1453 -522 2 1.65109 2.68456 3.32008 -5.2596 -5.54909 -2.36563 -523 1 4.11753 15.1048 9.79523 4.78264 -4.87511 12.6416 -524 2 3.99332 15.4569 8.91057 5.07926 -2.88804 -4.85995 -525 2 5.03278 14.7822 9.88586 -9.66079 5.58119 -5.37355 -526 1 7.25278 2.18203 14.6254 -0.555581 -14.0599 -5.06396 -527 2 7.1005 1.71681 13.7878 -2.90711 2.6098 7.34806 -528 2 7.71992 2.97108 14.3713 4.55177 12.8631 -2.10328 -529 1 18.557 14.6494 2.1729 -24.7771 22.3853 -4.36836 -530 2 0.778963 15.0461 2.09778 12.8139 1.02797 3.11036 -531 2 17.9275 15.4159 2.12338 10.4684 -24.8222 2.25012 -532 1 9.97282 2.76121 12.909 0.960373 12.9666 17.7509 -533 2 9.84581 2.0662 12.2717 -5.76657 -8.74665 -14.3806 -534 2 9.17654 3.31629 12.9308 6.08178 -3.78367 -5.74316 -535 1 2.89833 8.91803 13.044 14.9503 3.68581 0.826535 -536 2 3.29774 9.80788 12.9186 -7.17545 -13.4779 0.185991 -537 2 3.62224 8.34145 13.3619 -7.75262 8.46695 -4.72395 -538 1 3.21711 8.45664 3.69888 -1.45646 11.2765 -73.7917 -539 2 3.66926 9.20612 3.219 -10.9411 -20.3742 19.6072 -540 2 3.34915 8.55803 4.60102 11.7629 13.1896 57.1484 -541 1 5.60205 7.18882 8.56127 11.7766 6.17403 -13.6051 -542 2 5.73377 6.23122 8.60856 -5.21401 3.91262 5.39773 -543 2 5.15686 7.50265 9.34977 -6.87961 -7.75657 6.1504 -544 1 14.8989 1.38427 1.96946 -15.0866 25.6457 3.84218 -545 2 14.4906 2.19786 2.32837 7.96598 -16.9425 9.74227 -546 2 14.9786 1.62425 1.05302 13.5137 -6.97514 -15.0219 -547 1 8.3539 15.1902 0.828571 -0.607384 -15.7884 -3.69873 -548 2 9.11456 14.9295 1.35098 9.06641 9.90213 6.9538 -549 2 7.64957 14.6447 1.20074 -5.27592 0.575252 -4.39528 -550 1 15.5904 1.35118 7.21966 19.131 18.1941 14.0102 -551 2 15.0458 0.788774 6.70847 -19.486 -21.9805 -16.5491 -552 2 15.0172 2.08736 7.44992 -1.58717 6.06663 4.11757 -553 1 4.99095 13.0428 18.5017 -11.814 -5.03203 -22.7016 -554 2 5.38558 13.1981 0.699871 9.67176 2.40993 22.9792 -555 2 5.69857 13.2122 17.8695 -3.662 3.61759 -0.881885 -556 1 15.3616 8.52427 18.1264 -8.5134 -8.81723 23.808 -557 2 15.7284 8.98559 17.3934 10.1937 15.818 -24.0842 -558 2 15.2728 9.20414 0.16849 -1.83009 -5.75583 -0.912989 -559 1 12.0932 3.04939 18.3516 -14.5656 24.4873 8.42937 -560 2 12.4759 2.51827 0.417994 -2.38649 -9.33387 -9.98316 -561 2 12.2916 2.69447 17.4847 9.72648 -15.0074 2.48816 -562 1 13.2068 12.6815 5.17314 -7.19784 6.47098 -0.665029 -563 2 13.7108 11.8878 4.96601 4.53767 0.295949 3.70661 -564 2 13.3847 12.9363 6.09127 2.00425 -11.4311 -4.02895 -565 1 6.06883 7.14745 0.0914664 -7.81354 22.5487 2.98517 -566 2 5.88319 8.11419 0.19427 8.4279 -22.2037 -4.79949 -567 2 5.22519 6.72532 0.292473 3.10856 -0.243494 3.48057 -568 1 17.7194 15.9325 14.9871 -5.54638 -4.40987 -28.7902 -569 2 16.9069 16.4169 14.9498 -12.3977 10.2544 17.1316 -570 2 17.7594 15.7087 14.0393 19.0068 -3.79668 12.8095 -571 1 13.1727 0.977833 16.5926 -11.6444 6.00991 -1.45652 -572 2 14.0026 0.708875 16.9779 14.0624 -0.886732 -0.671765 -573 2 12.7076 0.152182 16.4397 -1.15444 -5.20647 -2.10321 -574 1 11.0384 14.6069 7.3103 -17.4066 -34.6271 2.52502 -575 2 10.2783 14.0261 7.58336 17.6612 20.778 -3.294 -576 2 11.8174 14.0391 7.44317 -4.14385 7.222 1.39489 -577 1 17.5379 8.55913 2.08836 4.35413 -11.6997 -13.5411 -578 2 16.664 8.39738 2.48219 7.20941 -2.48593 -6.20174 -579 2 17.6519 7.91106 1.34391 -7.20398 14.5397 25.454 -580 1 12.3635 7.91649 1.96817 14.6342 -23.934 -0.413214 -581 2 11.8532 8.69875 2.12901 -10.659 13.0689 -1.52352 -582 2 11.9409 7.3888 1.27378 0.548374 7.65925 3.61612 -583 1 11.9419 14.6308 10.3966 13.4402 32.5881 48.4479 -584 2 12.2905 14.0069 9.8182 12.9115 -34.2012 -37.3181 -585 2 11.0351 14.785 10.1903 -23.9611 0.860738 -9.13817 -586 1 6.84298 6.98317 15.5594 -28.1276 -29.1686 -18.0428 -587 2 7.705 6.91496 15.176 20.6419 5.27277 -3.3528 -588 2 6.85291 7.68491 16.1747 6.25697 23.8787 22.837 -589 1 8.01998 4.63032 13.4448 -35.0292 -26.7707 -36.5428 -590 2 7.42844 4.80515 12.6548 14.5268 -5.56395 32.2217 -591 2 8.43798 5.44118 13.6312 16.8653 30.885 3.99265 -592 1 13.3984 12.173 14.3104 -3.57217 10.7678 8.64565 -593 2 13.233 11.2355 14.1881 -1.19303 -4.98427 -3.70246 -594 2 13.8945 12.4998 13.5522 0.86121 -3.67781 -4.0367 -595 1 14.7231 9.47939 7.26845 -4.38272 9.59825 17.375 -596 2 15.5232 10.0108 7.49545 -18.3981 -9.5314 -3.88615 -597 2 14.0057 9.68134 7.91225 20.1628 1.06432 -13.939 -598 1 12.7179 16.9622 3.14627 23.4566 -37.2939 -10.6207 -599 2 12.9355 17.1415 4.04114 9.03221 7.6908 26.6047 -600 2 12.0213 17.5358 2.94483 -34.3001 33.1559 -14.5415 -601 1 1.10947 7.12267 17.419 -6.10821 -8.12856 16.9857 -602 2 0.178422 7.136 17.6887 4.23762 -2.5375 0.360706 -603 2 1.14096 7.54201 16.5672 -1.29203 8.00191 -14.7545 -604 1 12.8573 5.07319 15.6916 -26.4132 -0.426227 -0.347566 -605 2 13.5067 4.42508 15.4662 18.5417 -18.6841 0.103563 -606 2 13.3354 5.89586 15.6754 6.08426 15.3432 1.29959 -607 1 2.44451 3.37888 5.09109 -12.3042 -30.7639 -30.2825 -608 2 1.89914 3.20439 5.84354 -15.8924 -6.60657 16.2411 -609 2 2.9157 4.14854 5.30475 25.2943 38.046 11.4255 -610 1 8.30318 11.1757 13.537 -17.7368 31.3122 -83.5918 -611 2 8.23756 10.9827 14.4193 9.23305 -26.2584 72.471 -612 2 8.98641 10.7011 13.0548 11.9243 -7.18625 13.6047 -613 1 12.9121 1.44799 13.2982 3.17544 -30.959 19.595 -614 2 13.5829 1.31511 12.6431 13.7174 -5.57278 -14.8203 -615 2 12.5671 2.27513 13.0597 -18.9903 37.7092 -4.23536 -616 1 6.45025 13.6395 2.14169 21.7214 -12.6454 -10.4453 -617 2 5.88722 14.0323 2.78408 -20.3944 14.637 16.9787 -618 2 7.03563 13.0797 2.67163 0.317992 1.20831 -5.89746 -619 1 15.9341 6.54969 12.734 7.51439 18.2634 -8.82177 -620 2 16.366 7.12442 12.0552 -8.93517 -14.9663 18.1444 -621 2 16.3202 6.79095 13.5987 -1.79943 -6.04596 -11.4359 -622 1 16.8134 0.715269 9.59469 1.51011 24.5111 -1.75686 -623 2 16.9773 18.4324 9.6759 -2.99022 -25.9416 6.21625 -624 2 16.4855 0.841275 8.69831 -5.26956 1.43879 -3.58435 -625 1 6.14183 11.6821 8.34851 2.12045 33.7206 2.80541 -626 2 5.25373 11.5769 8.68031 -11.2997 -2.21294 6.8592 -627 2 6.41363 10.8186 8.10997 12.8023 -29.2169 -10.6172 -628 1 2.82878 8.69633 0.366162 65.7357 7.98524 25.914 -629 2 2.25196 8.1872 18.4995 -43.1364 -19.0897 -25.1642 -630 2 2.39827 9.3921 0.850531 -20.8372 5.7472 0.329713 -631 1 10.1125 10.4546 6.55694 -3.88563 -4.31924 12.8938 -632 2 10.5628 9.81084 7.11921 -1.26662 -0.776779 -0.718706 -633 2 10.7076 10.6109 5.83303 6.58413 -0.38446 -16.1853 -634 1 6.75197 15.7318 6.59922 10.1749 2.21511 -7.15796 -635 2 7.21229 16.0038 7.38721 0.121014 2.00215 12.9298 -636 2 7.17446 16.2736 5.9175 -9.12202 -3.23328 -2.5626 -637 1 6.44006 13.071 5.66115 9.01876 9.03356 -0.68679 -638 2 6.7952 13.9213 5.9766 -6.67057 -7.15315 -1.80184 -639 2 6.02558 12.6573 6.41982 -1.29087 -3.79345 3.79648 -640 1 16.7894 12.5351 9.7661 -6.01106 14.3853 23.3751 -641 2 16.9466 11.9627 9.02496 7.22561 -5.83165 -16.8213 -642 2 17.1452 13.4178 9.59292 -0.312151 -9.66884 -5.48162 -643 1 6.11103 2.94777 2.80745 -0.0522908 21.1759 -16.381 -644 2 6.20729 3.87808 2.49328 4.01665 -19.1858 15.5438 -645 2 5.82625 2.47942 2.01203 -2.73031 -5.31149 4.59086 -646 1 10.8562 3.22295 3.2592 5.83487 -6.01133 1.10343 -647 2 10.3184 3.99141 3.45824 -8.06424 0.347936 -1.44444 -648 2 10.5285 2.8344 2.43843 -2.26863 2.18612 2.83427 -ITEM: TIMESTEP -50 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.76267 6.9614 17.9655 18.039 1.32171 0.971735 -2 2 7.88851 7.04905 18.3237 -17.7355 -1.2272 4.07533 -3 2 8.77103 6.18416 17.4071 -1.73171 -4.43635 -4.46665 -4 1 18.7148 8.30367 6.79977 -11.0979 19.7573 -45.8218 -5 2 0.340011 8.13606 5.84126 -7.49685 -0.624375 38.3142 -6 2 0.514278 7.70743 7.38333 14.5888 -19.2797 9.57425 -7 1 8.47639 18.6969 6.83361 -13.2294 -1.25401 8.78355 -8 2 9.37315 0.218195 6.58559 19.0885 2.32763 -3.91705 -9 2 7.98208 0.748711 6.39478 -2.33131 3.58411 -1.86541 -10 1 6.52812 1.78346 11.693 -34.4751 -1.18092 9.20038 -11 2 5.67737 2.21709 12.0036 34.6116 -15.9045 -8.19534 -12 2 6.27488 0.856486 11.479 2.31906 19.7771 3.09659 -13 1 7.04596 5.66579 2.40189 46.2065 -42.3734 -14.42 -14 2 6.39782 6.00892 2.95716 -37.9245 28.3982 32.5204 -15 2 6.93615 6.04049 1.54428 -8.317 15.9019 -18.5798 -16 1 16.2302 10.236 16.0835 20.9593 -16.5275 2.4245 -17 2 17.1756 10.4542 16.2372 -23.2351 0.455296 -7.02457 -18 2 15.6872 10.9657 16.3738 0.757377 12.3052 3.78761 -19 1 10.6519 14.9414 2.32488 9.23959 14.6152 1.78567 -20 2 10.6414 14.4628 3.16471 0.797937 2.29677 -5.70575 -21 2 11.1604 15.7599 2.50148 -7.89724 -14.8548 -1.26363 -22 1 17.1653 8.24769 10.628 -7.00673 -3.15457 9.83212 -23 2 16.8168 8.85992 11.2947 -1.87186 0.196375 -6.64951 -24 2 17.9222 8.68524 10.2369 7.99899 3.60318 -1.68622 -25 1 14.7266 15.9157 16.4191 -13.8739 15.1565 -8.48964 -26 2 13.7936 16.2384 16.3951 24.1732 -8.40377 0.758561 -27 2 14.8582 15.5746 17.3097 -4.06225 -5.68183 -0.795501 -28 1 12.1165 13.3951 0.497647 12.4663 -12.7582 1.83308 -29 2 11.9617 13.3954 18.1814 -7.51799 5.11576 7.21512 -30 2 11.4424 13.8646 1.00511 -0.599491 5.86198 -7.65109 -31 1 9.3022 5.46358 3.98483 37.3 9.28522 -25.3544 -32 2 8.76176 5.25183 4.70521 -26.4917 -13.7331 37.3539 -33 2 8.69012 5.59126 3.27137 -14.2398 -0.31671 -15.324 -34 1 1.75646 4.13824 11.6126 7.13571 -34.631 6.10286 -35 2 1.57168 5.01735 11.8974 -3.49495 27.0073 7.26754 -36 2 2.15491 3.66767 12.3745 -6.50879 7.63382 -13.9832 -37 1 2.03017 6.80422 8.30837 9.29028 16.8447 12.8872 -38 2 2.52076 7.32809 8.97976 -10.1379 -7.93343 -11.4013 -39 2 1.79129 5.98703 8.76166 3.66627 -1.3648 -7.3534 -40 1 5.38278 4.45139 7.96045 1.48715 2.78745 -0.615366 -41 2 5.47525 3.53905 7.69237 2.73507 -15.0654 6.73754 -42 2 4.91072 4.84535 7.233 -11.388 9.54401 -10.9371 -43 1 3.30811 2.94776 17.4802 13.944 -42.282 -21.1312 -44 2 3.9986 3.21817 16.868 2.68053 3.29728 -0.298822 -45 2 3.01647 3.72731 17.8911 -19.397 34.8415 21.3069 -46 1 7.43048 5.35311 6.10326 -4.25319 -13.0158 -27.7806 -47 2 8.09022 5.89476 6.48364 23.034 26.3027 15.5228 -48 2 6.99872 4.97144 6.84559 -15.3695 -14.0963 19.964 -49 1 9.79676 7.01231 12.0156 -14.7328 3.59156 -15.7655 -50 2 10.3705 6.43202 11.4882 -9.23999 6.31012 5.56299 -51 2 9.04301 7.2927 11.4294 23.3546 -9.34629 13.9639 -52 1 14.0089 3.6286 8.06931 13.5755 5.11429 34.4728 -53 2 14.0074 4.36435 7.46412 -2.30693 7.62473 -7.33974 -54 2 14.3705 4.00595 8.91563 -10.4749 -13.1534 -24.8623 -55 1 4.55657 17.1558 3.95973 -9.28017 -24.3455 25.7085 -56 2 5.47914 17.3407 4.055 21.0307 11.7367 -4.03215 -57 2 4.1348 17.6911 3.31263 -3.95253 16.2794 -25.0192 -58 1 16.4751 16.614 10.2504 -32.3258 -7.85569 21.4695 -59 2 15.6275 16.6356 10.7813 29.977 2.99208 -16.9651 -60 2 16.2718 15.9944 9.53771 -1.01186 4.78751 -1.5712 -61 1 1.9619 4.81867 0.319959 -10.9755 -9.70287 -18.0846 -62 2 2.61752 5.08919 0.942567 15.1261 9.15008 18.4356 -63 2 1.74644 5.61951 -0.161427 -5.07436 5.04444 -4.19633 -64 1 11.5961 13.2841 16.3358 -4.45358 14.5896 10.2849 -65 2 11.0454 12.5131 16.3954 -10.7816 -16.1685 4.94665 -66 2 12.1536 13.1064 15.5876 11.3576 1.56581 -12.6168 -67 1 10.1325 11.0245 16.8746 -17.0839 37.329 0.881875 -68 2 10.5383 10.188 16.8005 14.1256 -36.2582 -1.95739 -69 2 9.19072 10.9065 16.7053 -0.138929 -3.60954 1.11764 -70 1 11.7656 17.449 13.475 -8.50487 25.248 2.18402 -71 2 12.3632 17.1066 12.8073 4.24528 -3.45864 -2.0733 -72 2 11.8231 18.4283 13.4081 4.57434 -16.4673 0.201387 -73 1 6.41878 9.35136 12.2283 -7.50229 14.2202 21.4939 -74 2 6.8057 8.89086 11.4896 12.6266 0.651555 -6.79619 -75 2 7.09031 9.88696 12.7035 -9.91308 -10.3657 -12.0835 -76 1 16.2619 12.8358 2.69678 7.42582 31.4023 -4.83963 -77 2 17.0939 13.3284 2.51069 -14.3032 -16.3414 4.28546 -78 2 15.5824 13.5473 2.68145 7.19887 -17.4175 4.43499 -79 1 0.698809 12.6212 5.89369 35.48 3.16674 13.5988 -80 2 0.938081 12.5288 4.97754 4.92149 -4.10163 -12.4931 -81 2 18.4194 12.7439 5.90006 -39.8609 3.63618 -4.1467 -82 1 5.237 16.4363 18.426 1.65878 -0.316472 9.22308 -83 2 5.81108 15.7548 18.0954 4.21498 -13.4949 -13.2329 -84 2 5.56972 16.5656 0.670239 -4.67124 7.34541 5.05152 -85 1 0.592121 7.69947 4.15467 -58.6061 -26.6762 36.9237 -86 2 18.6393 8.0928 3.5307 -12.7545 6.31849 -14.8448 -87 2 1.4218 7.85573 3.82511 72.6481 19.3185 -25.9209 -88 1 3.11983 8.96532 6.48794 54.6199 12.7003 -22.2767 -89 2 3.76913 8.45297 6.98254 -4.7725 1.8296 2.92636 -90 2 2.27977 8.75705 6.803 -46.0396 -12.4219 19.8369 -91 1 7.29807 10.3702 16.2638 20.6686 -0.114663 -24.6428 -92 2 6.66655 10.506 15.5642 -5.16108 2.7891 -5.34334 -93 2 6.78521 10.2638 17.0451 -10.3715 -1.64006 24.8745 -94 1 11.1174 0.987619 5.00277 -7.18116 3.53088 7.25248 -95 2 11.0089 1.86145 4.60844 7.25629 1.31859 -0.585836 -96 2 10.7387 0.391071 4.35918 -2.65397 -7.99376 -8.61355 -97 1 4.35641 2.82374 13.2083 -1.43301 42.1246 -29.6721 -98 2 4.74578 3.12447 14.0221 1.91906 -0.955597 13.0676 -99 2 4.17771 1.91012 13.264 -5.21231 -41.1093 14.0839 -100 1 8.41102 10.1748 1.81577 -7.29686 12.4487 -22.3398 -101 2 8.22152 10.8552 2.46036 0.4991 6.95458 5.373 -102 2 8.69583 9.43786 2.3232 10.7851 -24.1065 14.6426 -103 1 10.4306 1.70557 15.5491 18.4702 5.47966 -9.86629 -104 2 11.3921 1.67519 15.3716 -14.7227 -5.4908 8.94093 -105 2 10.0695 2.09393 14.7416 -3.28742 -2.92827 -1.64813 -106 1 2.67775 12.9037 7.82287 3.09642 7.69249 12.8714 -107 2 3.27779 13.5956 7.51776 -0.922255 -1.64886 -5.76029 -108 2 2.01429 12.7843 7.13996 -0.0248334 -2.64481 -5.98892 -109 1 3.74038 11.6511 5.07858 19.3958 17.4162 2.05128 -110 2 3.60589 10.7736 5.39333 -4.06789 -18.6575 13.0804 -111 2 3.07486 11.8033 4.42286 -17.2397 4.77378 -8.56343 -112 1 6.72135 14.4316 16.9296 11.8603 14.2358 -0.0778856 -113 2 7.64698 14.6853 17.0511 -5.38436 -3.23295 2.03342 -114 2 6.43726 14.8986 16.1349 -2.65892 -7.20284 -3.09426 -115 1 14.1884 14.544 3.35185 -21.8252 -0.368401 10.0779 -116 2 13.5247 15.1958 3.05461 14.5314 -4.887 4.26149 -117 2 13.7567 14.0734 4.09815 10.0173 4.52685 -16.1607 -118 1 8.41325 18.11 16.0503 -13.4237 14.7481 -2.40694 -119 2 9.01353 17.4146 16.1754 14.4883 -45.0972 12.851 -120 2 9.02228 0.139466 15.7926 3.66197 31.0187 -5.55304 -121 1 4.74026 1.68368 4.91774 -8.81747 -38.2992 48.653 -122 2 3.89365 2.07173 5.09257 -16.8489 9.86366 -0.181142 -123 2 5.05165 2.08173 4.1548 23.8621 30.7653 -48.3713 -124 1 15.012 12.6397 16.4637 21.182 -20.8114 -27.7575 -125 2 14.6363 13.1316 17.1743 -19.1608 12.2632 11.0748 -126 2 14.4002 12.4571 15.7145 4.23163 12.8017 20.733 -127 1 15.7141 18.464 16.8736 -48.8091 1.63943 -48.6642 -128 2 16.4537 18.5656 17.3974 52.451 1.55627 42.8989 -129 2 15.6088 17.527 16.6934 -4.99653 -8.13868 6.26406 -130 1 1.24245 1.19714 16.5568 -3.35795 -9.15112 -9.15157 -131 2 2.06126 1.67967 16.5955 12.2536 9.19 1.95012 -132 2 0.738255 1.56007 17.2754 -9.1343 5.49748 13.2621 -133 1 18.1403 4.48045 15.9024 -8.92064 9.41796 12.6958 -134 2 18.2534 3.91822 15.1507 3.10214 -9.7063 -13.7449 -135 2 0.333051 4.53253 16.3579 6.8431 0.540548 1.72555 -136 1 12.2576 16.9773 16.1451 24.3374 26.4028 -39.8206 -137 2 11.5235 16.7559 16.6626 -39.484 -19.8089 22.2101 -138 2 11.9275 17.1263 15.229 8.36672 -7.61232 16.8746 -139 1 16.0311 2.54163 18.1267 15.2184 -17.5558 18.8253 -140 2 15.6351 3.35325 18.4083 -9.02057 20.5203 4.48377 -141 2 15.9018 2.48695 17.1953 -7.32995 1.76863 -25.4669 -142 1 6.72575 13.8191 10.1968 -9.26978 -14.9128 -14.7006 -143 2 6.45064 13.4802 11.0509 2.35225 3.79258 9.11016 -144 2 6.47529 13.1065 9.58166 7.75573 8.69288 2.20437 -145 1 10.1667 18.3423 2.73278 -21.0918 -24.4685 17.5154 -146 2 10.3808 0.422697 2.17354 8.51297 19.7321 -20.8009 -147 2 9.25877 18.0911 2.47579 12.4496 3.13566 3.08398 -148 1 3.02618 17.7182 6.12046 9.12785 6.17449 -5.85825 -149 2 2.19895 17.4959 5.67953 0.482163 3.05546 -3.6427 -150 2 3.66706 17.9189 5.4073 -11.2068 -9.39986 11.0759 -151 1 12.5962 16.8879 7.98687 8.69067 0.386489 -7.96768 -152 2 11.911 16.2378 7.93697 -12.2796 -18.2514 -9.64148 -153 2 12.3467 17.3792 8.75804 4.49939 18.0195 12.184 -154 1 14.8895 15.2713 8.19847 3.78441 6.77747 -24.1674 -155 2 14.0908 15.8092 8.10802 0.530475 -1.70182 9.59272 -156 2 15.3507 15.4528 7.3473 -4.11878 -7.96121 22.2836 -157 1 17.7044 18.2264 0.345927 53.2191 22.2557 3.1655 -158 2 18.611 17.8064 0.306571 -34.334 1.581 -6.33561 -159 2 17.9464 0.534475 0.465882 -17.8927 -21.106 -0.514669 -160 1 0.816649 10.4426 1.34739 14.8692 48.9775 -23.6448 -161 2 0.0612409 10.0129 1.68761 -29.4632 -23.0248 11.5333 -162 2 0.465717 11.2339 0.843051 15.2672 -28.7963 15.4324 -163 1 1.72991 12.2406 3.39174 -15.9976 -2.88445 -44.3457 -164 2 1.42407 11.5936 2.70825 8.45982 5.87631 22.8389 -165 2 1.72198 13.0652 2.87637 5.68226 -3.3333 12.0496 -166 1 0.611993 17.231 4.90821 -34.3512 10.3394 53.8078 -167 2 18.7649 18.0776 4.93361 14.0145 -8.94618 -14.8948 -168 2 0.320128 16.8659 5.79609 20.9887 -2.41003 -36.5782 -169 1 1.10304 0.897417 9.42158 -11.0752 -12.4205 -5.86027 -170 2 1.33193 0.471936 10.271 -7.8206 6.77035 -10.9921 -171 2 0.260273 0.49253 9.11811 18.1645 10.0729 11.6017 -172 1 16.7431 2.34345 13.2996 -3.12231 -7.25082 27.0749 -173 2 16.9139 2.55723 12.403 6.00909 8.65593 -29.5603 -174 2 16.479 1.41627 13.3001 1.0866 -1.80785 3.13205 -175 1 2.64585 15.864 12.1283 -21.2463 14.7527 -7.08654 -176 2 3.15605 15.3934 12.7599 11.6364 -10.3414 18.5671 -177 2 3.00262 15.6045 11.2815 4.79088 -2.17896 -11.8296 -178 1 16.4298 15.6598 6.07287 -23.7839 -45.9221 18.6798 -179 2 17.316 15.6562 6.39936 21.0579 5.20152 4.08476 -180 2 16.3078 16.3335 5.44341 2.1367 33.4546 -25.3893 -181 1 5.80337 5.0927 11.7988 -16.1764 10.2154 8.68093 -182 2 5.24436 5.75105 12.277 17.1169 -11.9851 -7.24057 -183 2 5.28663 4.27668 11.796 1.81497 4.13117 2.00496 -184 1 15.1635 4.86687 0.779797 10.276 15.6296 -42.8981 -185 2 15.0374 4.47718 1.61189 -4.55383 -15.7546 43.9488 -186 2 14.356 5.34586 0.597493 -2.57536 1.02491 -2.93315 -187 1 16.3458 16.3763 2.04771 3.47576 3.66541 23.8501 -188 2 16.2044 16.7006 2.97252 -3.72753 -7.68524 -25.3267 -189 2 16.7389 17.1226 1.58867 -0.552753 3.82143 -4.99822 -190 1 0.255881 4.83863 3.82235 -11.3764 -61.9515 -5.66134 -191 2 0.347221 5.7447 3.93716 8.7619 60.1171 8.48532 -192 2 0.834328 4.39842 4.45398 2.37129 4.71095 -1.99834 -193 1 2.9563 15.0569 15.1257 1.71124 8.82343 -41.1566 -194 2 2.85861 14.8634 16.033 -5.32392 -14.5435 34.6784 -195 2 2.48389 15.8911 15.0234 3.12674 0.885842 0.387353 -196 1 1.13777 14.6522 9.5263 -30.3315 0.106042 24.0606 -197 2 1.89024 14.3075 9.07024 17.4708 -15.5826 -4.95385 -198 2 0.933623 14.0402 10.2733 8.29602 9.54759 -23.1661 -199 1 13.5292 16.584 11.5416 25.6454 -21.6132 21.0377 -200 2 13.328 17.2834 10.9465 -13.4726 19.9213 -18.5602 -201 2 13.2496 15.765 11.1158 -9.99742 3.11837 -0.28929 -202 1 4.66126 1.44669 0.76776 24.0608 13.759 -10.2694 -203 2 4.19513 2.00271 0.14116 -5.95148 5.85957 -2.67997 -204 2 4.06121 0.755814 1.00952 -11.6339 -11.0076 11.757 -205 1 1.46276 18.5641 11.8468 9.16484 -20.9655 21.4802 -206 2 1.29795 0.448688 12.6433 2.09315 -1.75191 -4.75625 -207 2 1.84947 17.7191 12.1761 -6.39306 18.521 -9.12508 -208 1 11.4915 10.1299 3.99438 -29.0311 -19.3551 44.8744 -209 2 11.2201 10.4871 3.17848 -8.25775 15.5063 -35.6965 -210 2 12.4189 10.233 4.02648 37.0944 1.09916 3.99775 -211 1 8.27499 12.1796 3.66337 18.6814 -7.12196 -36.2468 -212 2 9.0689 12.5922 3.98877 11.875 7.24467 3.22649 -213 2 7.6764 12.2152 4.36849 -32.1167 2.17346 40.1921 -214 1 14.4874 4.01368 3.28039 -17.5005 -0.0616197 -21.9184 -215 2 14.9648 3.93911 4.08552 21.5727 -0.139675 21.9436 -216 2 13.7566 4.60071 3.48465 -5.84393 1.34015 1.64127 -217 1 5.62374 1.66322 7.51635 70.0554 58.4457 -44.6253 -218 2 5.02312 1.16941 7.9611 -67.4835 -53.4064 45.1295 -219 2 5.39821 1.60037 6.57846 0.425083 -1.20148 0.902483 -220 1 17.8844 1.0604 4.85627 -10.0966 -7.93422 8.12116 -221 2 18.57 1.49808 4.37578 15.6561 4.82809 -15.3219 -222 2 17.6975 1.64814 5.58583 -4.12013 1.11537 7.77052 -223 1 6.80576 9.4106 4.49942 14.9318 -4.14838 16.3077 -224 2 6.92469 9.61899 5.44741 -8.81338 -3.93454 -14.2946 -225 2 7.68422 9.10473 4.22333 -4.88591 1.73472 -0.668879 -226 1 2.61188 14.876 1.98504 -6.91902 -4.93882 19.1315 -227 2 3.25848 14.7083 2.68056 -2.68924 0.660774 0.84214 -228 2 3.12462 14.9058 1.19269 5.2127 1.18228 -19.2613 -229 1 17.303 12.9246 13.1525 10.3788 -12.5807 -3.95397 -230 2 16.4389 13.2985 13.3385 -0.36563 10.0164 -0.276732 -231 2 17.9169 13.6449 12.9311 -14.7092 -1.11942 1.9762 -232 1 14.9246 10.553 1.38722 24.8563 30.4026 18.8772 -233 2 15.5245 11.2788 1.76222 -27.4309 -28.2887 -15.3922 -234 2 14.0162 10.8271 1.54897 4.06804 -0.689498 -1.36825 -235 1 5.72717 6.70809 4.58418 -6.56467 23.581 -8.85087 -236 2 6.06385 7.62371 4.66236 -8.01259 -10.4186 -5.73866 -237 2 6.2767 6.1943 5.16785 8.48743 -6.29877 6.22452 -238 1 8.0009 8.33508 10.3687 14.1913 1.83663 -35.3126 -239 2 8.52082 9.13006 10.161 -0.0651459 -5.63876 7.89795 -240 2 7.94932 7.91253 9.48819 -6.75295 -2.00865 18.056 -241 1 13.4409 18.4268 5.72382 16.6357 0.722738 -15.7997 -242 2 12.6296 0.221713 5.47389 -5.04693 11.9449 -2.85301 -243 2 13.1936 17.8965 6.46343 -5.47963 -14.8645 21.1785 -244 1 0.0859293 2.63743 0.236192 -9.12202 -35.143 -2.56963 -245 2 17.9325 2.9505 -0.168165 -24.3821 -4.07692 -4.34214 -246 2 0.590564 3.4143 0.297916 33.333 32.0117 7.87133 -247 1 12.8395 11.0444 9.74231 45.1743 -31.9509 26.4779 -248 2 11.9686 11.0602 9.42407 -43.5447 -1.91263 -10.9888 -249 2 12.9558 10.1388 10.1456 -3.41612 23.6256 -14.6869 -250 1 0.710059 12.1592 11.0756 -10.531 -0.362272 -11.4251 -251 2 18.3753 12.1255 11.106 13.0957 4.94421 7.25875 -252 2 1.07349 12.4339 11.9177 -3.83141 1.58371 11.017 -253 1 5.10203 7.3136 13.4291 15.7719 5.5957 -0.396148 -254 2 5.6162 7.93373 12.8769 -6.75271 -3.40235 8.70115 -255 2 5.62723 7.25347 14.2483 -7.64248 -3.9813 -9.01905 -256 1 1.21129 6.85545 11.8946 29.9494 36.4661 12.0403 -257 2 0.485742 7.25442 11.415 -4.88796 -0.516932 -2.56673 -258 2 1.80546 7.64481 12.127 -26.2797 -36.2571 -7.59378 -259 1 15.5076 9.61367 12.3051 21.7085 -42.1446 -13.9552 -260 2 15.1772 10.4675 12.1584 -16.5272 42.565 -1.064 -261 2 15.3545 9.37182 13.2055 -3.21788 1.51701 18.7315 -262 1 16.6116 12.7513 5.5295 7.16384 -7.58562 22.1279 -263 2 16.3878 13.6701 5.61583 -3.61437 18.1746 3.54477 -264 2 16.4616 12.5615 4.61757 -3.38991 -5.42355 -25.0954 -265 1 6.3014 9.86096 0.0280098 12.3864 1.00447 14.78 -266 2 5.6246 10.4136 0.42972 -1.13337 -0.2267 2.50286 -267 2 7.03571 9.82087 0.686012 -15.2579 5.10695 -14.0237 -268 1 12.3034 6.12839 4.06739 18.1147 15.8957 -28.6536 -269 2 12.3348 6.66771 3.23063 -4.28261 -10.1618 29.3394 -270 2 11.5855 5.52112 3.9529 -14.8183 -8.35162 -1.01689 -271 1 0.289245 12.8118 0.17396 1.00074 4.7721 1.62068 -272 2 0.031574 13.4709 0.828681 0.933398 1.09562 1.96647 -273 2 18.4473 13.0492 18.0252 -3.3255 1.79332 -7.06642 -274 1 3.67377 18.6092 8.59256 -12.2718 12.3972 8.90671 -275 2 3.51633 18.2244 7.72678 0.0355868 -3.61867 -2.60117 -276 2 2.80982 0.36536 8.82196 13.0622 -5.69839 -0.636093 -277 1 7.44701 17.3263 4.47819 -12.2479 -42.1382 8.27198 -278 2 7.47198 18.2285 4.71954 7.46065 34.1282 3.2472 -279 2 7.59543 17.2523 3.54279 -0.328999 6.68987 -14.4609 -280 1 9.24493 17.1077 12.2387 -39.9724 15.9122 -7.56371 -281 2 9.27102 16.3677 11.6468 4.90539 -16.8252 -9.88175 -282 2 10.091 17.2207 12.6154 35.0883 -2.17581 15.9571 -283 1 13.2831 12.983 8.01599 31.7457 23.9761 -1.258 -284 2 13.3856 12.1913 8.53584 -3.88389 -9.78552 5.15809 -285 2 14.1414 13.4672 8.16531 -29.1617 -3.59582 -8.01118 -286 1 14.8948 2.98524 15.3712 -17.5751 0.764594 21.5491 -287 2 14.1876 2.34218 15.2724 -1.25262 -5.58382 2.64656 -288 2 15.4061 2.89645 14.5861 17.2961 2.13088 -20.5882 -289 1 9.89537 15.5662 16.9902 -4.09035 4.17693 9.89685 -290 2 10.2983 14.7234 16.7502 5.73332 1.10161 -2.59445 -291 2 9.67249 15.5035 17.9343 -2.60097 -1.56266 -9.87078 -292 1 11.3274 8.38795 16.5853 -21.4847 -13.5698 4.02619 -293 2 10.6433 7.93033 16.0536 12.1725 7.69909 5.41873 -294 2 11.2563 7.95351 17.4557 6.17465 6.37506 -11.4872 -295 1 3.9593 18.2162 16.7697 0.697619 -14.1615 -14.1273 -296 2 4.40283 17.477 17.2226 -3.01571 14.2153 3.03122 -297 2 3.77495 0.26362 17.3949 3.98021 5.349 11.1126 -298 1 2.22376 4.19593 8.92134 -23.2189 1.10906 -21.9008 -299 2 3.13693 4.25168 8.71451 27.6214 0.869066 -8.80864 -300 2 2.192 4.13003 9.85498 -3.77747 -6.53541 33.4183 -301 1 9.87956 10.3806 9.72418 15.1316 -34.7661 11.7533 -302 2 9.43202 11.1334 9.41625 -17.3542 37.4051 -17.5479 -303 2 10.0318 10.5223 10.6578 4.66737 -1.93825 10.7585 -304 1 9.70627 0.903434 10.8708 -16.6391 -17.8124 -8.64764 -305 2 9.32253 0.0380009 11.0933 9.22807 5.63208 7.52542 -306 2 9.08638 1.2149 10.1967 9.10725 8.78511 -0.274781 -307 1 9.19757 15.1031 10.2247 30.2853 16.2782 3.75492 -308 2 8.7691 15.7671 9.69642 -6.57671 14.9232 -6.79792 -309 2 8.58248 14.3993 10.2376 -24.9838 -23.9988 3.33467 -310 1 0.938497 9.56303 10.2766 -19.6808 1.12411 10.869 -311 2 0.864208 10.4264 10.69 -4.58503 2.29603 -0.877129 -312 2 1.8082 9.5891 9.92621 21.6362 -6.44505 -13.6115 -313 1 17.0002 4.85339 8.15215 21.2107 4.17599 -32.9154 -314 2 16.5226 5.60356 8.44909 -16.9553 23.1583 5.35412 -315 2 16.856 4.21761 8.81327 -1.81027 -27.4365 28.1652 -316 1 14.7301 14.7112 0.178334 14.6842 0.804622 -15.2869 -317 2 15.1474 15.2511 0.844024 6.42123 6.45952 11.8737 -318 2 13.9865 14.3021 0.591484 -20.7841 -7.92944 9.37323 -319 1 3.69091 11.0487 9.53568 5.98335 -8.96355 13.8332 -320 2 3.56651 11.2839 10.4631 4.16949 4.48414 3.3219 -321 2 3.23005 11.7193 9.04032 -8.2098 7.45463 -11.8198 -322 1 11.2005 10.7579 1.45634 -8.62161 -19.8695 4.90197 -323 2 11.5404 11.5862 1.17391 12.694 26.4047 -12.3165 -324 2 10.2904 10.7467 1.15081 -4.44873 -2.97897 0.910453 -325 1 13.1494 7.14877 12.735 25.4211 -2.46103 0.847156 -326 2 14.1287 7.02261 12.7655 -19.3043 2.68773 1.11168 -327 2 12.7806 6.27183 12.8763 -3.1166 -1.04351 -1.25783 -328 1 9.62343 1.89491 0.979311 -12.9604 6.63616 -29.4885 -329 2 8.7946 1.64267 0.49669 19.6199 4.62861 14.6045 -330 2 10.1494 2.42868 0.345455 -5.12075 -11.8177 11.3147 -331 1 10.6335 13.514 4.5646 -17.0056 -0.486025 -1.57099 -332 2 11.3585 12.913 4.68456 17.6411 -7.84828 -0.965736 -333 2 10.6299 14.042 5.36013 -0.769181 5.74096 10.189 -334 1 14.4133 1.73933 10.9414 -11.8391 -17.207 6.29742 -335 2 15.2077 1.35218 10.5638 5.14778 2.73806 -3.87278 -336 2 14.5015 2.69292 10.9149 5.22965 5.71868 -2.86675 -337 1 14.5722 12.1975 11.686 14.094 -1.05888 37.2495 -338 2 15.3017 12.3928 11.129 31.2021 7.92611 -10.369 -339 2 13.8916 12.0994 11.0714 -43.9062 -9.54665 -27.6985 -340 1 8.20779 5.06885 9.81189 17.2837 -27.279 -13.9945 -341 2 7.476 5.2926 10.3565 -21.7486 9.79802 13.7153 -342 2 8.11585 4.0945 9.69767 5.61634 21.6585 -4.44102 -343 1 1.51211 16.8659 18.4077 -7.21278 -21.5738 6.32543 -344 2 1.92778 17.2486 17.641 3.99023 3.9685 -12.2343 -345 2 1.4425 15.9033 18.1995 7.9863 23.2313 7.90302 -346 1 1.50475 17.27 15.3217 -52.6385 22.4638 18.049 -347 2 1.49283 18.1952 15.6793 7.67726 -26.1665 -10.1971 -348 2 0.544177 16.9836 15.4083 37.5739 4.67989 -9.3974 -349 1 3.64958 5.72975 6.08508 6.29069 -26.5723 -11.3796 -350 2 3.20343 6.25343 6.73323 -12.457 15.9806 12.721 -351 2 4.14586 6.29176 5.4852 3.70859 6.95385 1.18178 -352 1 12.4272 9.46789 14.1967 -22.2867 60.9428 4.59069 -353 2 12.8141 8.72569 13.8244 25.5413 -52.6107 -24.0302 -354 2 12.2248 9.22264 15.0865 -2.36671 -8.29514 20.866 -355 1 4.05215 15.2773 6.93811 -37.3363 -16.6714 15.1212 -356 2 3.52112 16.0418 6.69595 1.88806 4.21981 -3.16255 -357 2 4.93922 15.5036 6.7631 37.0693 10.9568 -7.31607 -358 1 0.634621 8.6113 14.9988 -1.00168 -8.57623 6.03626 -359 2 0.426563 9.53409 15.1284 -0.450123 11.8509 1.14186 -360 2 1.36493 8.60238 14.3834 7.02364 0.17651 -8.78598 -361 1 12.9488 8.28918 10.2591 -12.3232 2.05195 12.3522 -362 2 13.6164 7.77926 9.80228 8.67745 -2.84232 -3.45719 -363 2 12.9296 7.914 11.161 -0.920073 6.75149 -12.343 -364 1 15.3287 7.72887 3.53701 30.7324 40.0945 -27.1654 -365 2 14.5687 7.40616 3.08394 -23.025 -16.3354 4.19175 -366 2 15.5452 7.39964 4.39595 -10.5646 -17.2283 18.769 -367 1 17.3078 6.69366 0.0430756 19.9915 -9.88107 5.38445 -368 2 16.7705 5.94464 0.294276 -4.0765 -7.9871 3.32428 -369 2 16.6874 7.33606 18.3865 -21.7939 19.8828 -6.94939 -370 1 8.91017 6.93043 7.77699 23.4025 28.7729 -7.70378 -371 2 9.81824 7.33337 7.84479 -23.824 -15.1706 -1.9244 -372 2 8.86104 6.22236 8.40836 -0.772968 -13.4081 16.1446 -373 1 12.3843 0.611213 1.25908 1.98263 -0.697807 -4.79042 -374 2 13.323 0.393307 1.31761 -0.925839 8.32556 5.35041 -375 2 12.1237 0.465738 0.350227 -1.33982 -4.5367 -2.71568 -376 1 5.61465 15.1448 14.5392 -1.26631 -30.1046 6.25467 -377 2 4.66418 15.2406 14.6702 -0.2102 4.52428 0.84195 -378 2 5.97383 15.921 14.1393 5.11494 24.4221 -7.05072 -379 1 3.84895 6.44034 1.72963 2.7696 -8.11358 7.79979 -380 2 3.51864 7.3032 1.48291 -7.06055 11.1725 -5.60147 -381 2 3.99368 6.51729 2.68239 -0.0521329 1.22822 -5.4234 -382 1 3.90083 11.5778 12.3664 -12.9911 -8.32668 -3.5509 -383 2 4.78352 11.9371 12.4749 4.25232 1.56379 3.39016 -384 2 3.29545 12.1182 12.8978 7.28302 -2.19426 -6.07273 -385 1 5.34262 3.87885 15.873 -6.15348 -82.0204 -11.7996 -386 2 6.0076 3.23261 15.5032 -15.8888 19.1459 15.4213 -387 2 5.69117 4.71679 15.7838 27.5644 60.3601 -6.10452 -388 1 14.3156 10.2471 4.51115 -35.9806 40.7967 42.7391 -389 2 14.5125 9.92103 5.39777 -3.50802 -2.54983 -0.445713 -390 2 14.828 9.75135 3.94137 33.3968 -38.7315 -40.7643 -391 1 7.75287 17.3919 9.13705 13.5919 -13.2315 -4.02741 -392 2 6.89819 17.6363 9.44363 -21.9658 0.853712 16.3055 -393 2 7.88604 17.9611 8.38483 9.7933 6.77297 -11.9047 -394 1 4.50916 14.5069 3.91348 -1.14645 -26.1805 -53.139 -395 2 4.48781 15.3883 4.18695 -0.715057 47.311 12.47 -396 2 4.59583 14.0061 4.68593 4.03467 -28.7439 39.2156 -397 1 14.2649 7.40032 15.8248 -22.801 -12.9293 -21.4811 -398 2 15.1988 7.32934 15.7188 25.9215 -1.64325 -3.33443 -399 2 14.1282 7.83404 16.6492 -0.714938 9.98648 22.5393 -400 1 3.02257 18.338 1.93829 -9.63799 -32.7056 -36.1055 -401 2 2.55646 17.7535 1.2554 15.187 19.9859 31.9951 -402 2 2.37728 0.279403 2.32429 -11.6166 9.08866 3.80637 -403 1 7.9856 1.63208 4.58686 -21.2194 7.37107 -10.8429 -404 2 7.46714 2.08087 3.89599 -2.9365 -3.17783 11.7342 -405 2 8.82293 1.5175 4.16848 19.7493 -4.53145 -2.81354 -406 1 2.46603 14.1528 17.6814 26.4379 24.7021 -16.3984 -407 2 1.84119 13.6421 18.1459 -27.3849 -25.1212 16.5566 -408 2 3.3203 13.7773 17.9154 6.17156 -2.74614 2.81365 -409 1 0.847673 1.77812 13.8995 -29.1857 4.71799 7.40329 -410 2 0.70153 1.57851 14.8469 9.71331 1.1605 -15.3576 -411 2 18.5888 1.96886 13.5517 20.2657 -3.94578 7.10705 -412 1 4.44078 18.6823 13.9019 -16.0244 4.84661 7.61196 -413 2 5.30649 18.3093 13.8135 20.8517 -5.19628 -2.25594 -414 2 4.21344 18.5423 14.8331 -2.2181 0.553195 -4.50589 -415 1 7.17333 0.707602 18.3659 18.5924 -14.7376 -19.2949 -416 2 7.29313 0.222373 17.5065 -5.17699 16.3575 23.4569 -417 2 6.28409 1.05221 18.4099 -11.4153 -0.902781 0.0516699 -418 1 16.0458 18.3995 13.9929 19.922 2.02833 15.0786 -419 2 15.1358 18.307 13.8248 -34.099 -5.52537 -15.9309 -420 2 16.0494 18.5146 14.948 8.19193 5.7614 4.60276 -421 1 10.1078 4.56818 16.2539 38.806 25.935 -8.65561 -422 2 11.0636 4.83663 16.0361 -35.078 -16.4147 14.4025 -423 2 10.0818 3.61692 16.3176 2.43484 -11.3153 -3.34335 -424 1 15.9163 17.7591 4.46968 32.0074 -29.6155 -15.1132 -425 2 16.5099 -0.143617 4.50341 7.95185 14.4383 0.237761 -426 2 15.1003 18.0575 4.79025 -43.3278 16.7712 13.4837 -427 1 7.00774 17.4246 13.8321 -56.0949 -7.97771 -22.4327 -428 2 7.49162 17.6994 14.5684 25.5375 13.311 41.1471 -429 2 7.64463 17.2266 13.1734 23.6351 -3.93018 -21.4132 -430 1 13.2756 6.47326 6.61789 23.4956 20.1255 -14.8261 -431 2 14.0898 6.99784 6.40679 -18.3755 -16.6425 15.9473 -432 2 12.9103 6.33261 5.73881 -7.54238 -3.20295 2.17295 -433 1 7.79764 2.32743 9.30513 0.620653 -0.611916 41.3127 -434 2 7.26457 2.16571 10.1169 11.5422 6.28076 -11.6799 -435 2 7.22158 2.07024 8.60986 -14.5852 -6.72752 -26.4814 -436 1 15.1722 14.8472 13.687 6.75051 -12.1688 -2.41191 -437 2 14.9232 15.197 14.5358 -2.94711 1.82763 14.9216 -438 2 14.8185 15.4404 13.0388 -8.36185 8.62669 -11.0165 -439 1 9.38377 8.31795 3.7734 -21.5197 15.3047 -10.1967 -440 2 10.1883 8.66352 4.14356 14.5642 4.86611 3.27566 -441 2 9.4002 7.3753 3.8765 5.94621 -16.0238 5.03493 -442 1 17.77 13.5913 16.4331 -7.58631 -31.5789 18.0626 -443 2 16.8485 13.2919 16.3991 0.887673 4.05725 -0.920823 -444 2 17.783 14.4232 15.9937 -0.095827 22.773 -14.6224 -445 1 4.93053 10.5741 2.80353 -17.5831 18.6377 -10.1976 -446 2 5.6584 10.2884 3.33403 15.5926 -12.1878 10.3648 -447 2 4.56303 11.3186 3.30761 3.36544 -9.45409 -4.10473 -448 1 3.72361 8.36764 10.1215 3.29328 14.9495 -8.98506 -449 2 3.89363 9.29817 9.8724 -2.16289 -13.6958 -0.787578 -450 2 3.61222 8.39575 11.0685 -3.0862 -1.08413 10.2171 -451 1 15.9739 6.97387 6.06952 -13.2047 20.7109 0.201327 -452 2 16.7663 7.43242 6.33309 11.9845 5.69104 3.28059 -453 2 16.2425 6.10629 5.81378 6.71976 -25.6546 -0.898294 -454 1 15.1226 7.10933 9.08497 -8.54326 -39.6564 44.8588 -455 2 15.7377 7.52152 9.6861 12.0306 8.12876 4.18876 -456 2 15.1451 7.58697 8.30383 2.04885 32.3579 -51.8464 -457 1 6.29947 12.9646 12.7695 3.37722 -4.66482 -6.66232 -458 2 7.17165 12.6249 12.9809 1.24175 -10.0492 1.61343 -459 2 6.12977 13.6114 13.4445 -6.34808 15.4581 9.54933 -460 1 12.1164 4.51054 13.0962 -37.6646 -34.1548 1.17408 -461 2 12.2607 4.59773 14.0409 7.03003 6.16295 4.50476 -462 2 11.318 3.89029 13.036 30.5495 29.2935 -6.64922 -463 1 11.3767 8.15056 7.89733 -18.501 8.72492 -14.0328 -464 2 11.9999 7.57003 7.45959 11.3303 -6.40222 -0.944592 -465 2 11.6722 8.28384 8.79215 9.56916 -2.23029 14.0742 -466 1 17.1624 10.8628 7.5038 -34.939 16.2827 29.0255 -467 2 17.7665 10.1757 7.31962 29.6392 -23.074 -13.6235 -468 2 17.1223 11.4937 6.79065 1.17945 1.22203 -15.4432 -469 1 5.28569 18.1322 10.989 31.979 0.201705 -2.44437 -470 2 4.81806 17.865 11.7612 -14.4656 -7.34411 17.8618 -471 2 4.63582 18.2948 10.3295 -20.6991 2.34913 -21.9288 -472 1 7.59755 17.5197 1.78957 -4.56355 -5.70379 -23.6831 -473 2 7.90081 16.7255 1.29504 -6.23989 15.492 10.1621 -474 2 7.18064 18.108 1.12072 15.1074 -6.58967 11.1205 -475 1 1.93009 12.8809 13.5782 -3.15102 -7.76664 -18.9393 -476 2 1.45787 12.3423 14.2065 -6.90584 -5.9659 9.51664 -477 2 2.19823 13.666 14.0335 5.43227 17.0545 14.7464 -478 1 9.58089 6.76558 14.8178 3.72821 -35.8509 -10.9213 -479 2 9.75861 5.80832 15.0417 -6.66727 32.4051 0.0155959 -480 2 9.77461 6.83059 13.8656 0.408011 6.2359 8.07479 -481 1 15.2957 4.27102 10.7659 9.27088 14.9202 31.1326 -482 2 16.1322 3.95288 11.1528 -7.49935 1.06904 -21.0932 -483 2 15.0846 4.9939 11.387 -3.9034 -8.13187 -14.3813 -484 1 11.2455 6.18064 0.162868 26.0255 26.7031 14.5737 -485 2 11.4763 5.37121 18.3763 -4.81733 -21.4086 -8.3593 -486 2 10.308 6.3098 0.211594 -20.2553 -5.22819 -8.60243 -487 1 0.00824002 11.3791 15.0352 26.3856 -8.14992 32.1511 -488 2 18.096 11.5216 14.3022 -25.0888 8.62779 -34.0528 -489 2 -0.201285 12.127 15.606 2.8625 2.75044 1.90901 -490 1 7.02689 9.25213 7.27678 19.2929 16.5016 -4.78745 -491 2 6.59278 8.51389 7.67295 -14.5933 -20.8184 8.5158 -492 2 7.9603 9.00351 7.26624 -3.73747 1.30273 -1.02295 -493 1 18.3276 15.3446 12.3362 -3.78489 -4.33158 3.75643 -494 2 0.608087 15.5074 12.1532 11.0792 5.95639 -3.98767 -495 2 17.812 15.8736 11.72 0.968766 1.6464 -4.64437 -496 1 16.5183 4.40219 5.2766 -9.25512 24.5768 -59.2644 -497 2 16.7942 3.98653 6.05327 18.9035 -16.7679 44.3388 -498 2 17.2936 4.55111 4.6869 -10.7937 -7.24122 14.527 -499 1 17.7074 3.16435 10.7411 -7.07567 -19.8863 -1.17515 -500 2 18.5775 3.40914 11.0222 18.8337 10.6004 6.41913 -501 2 17.8312 2.27039 10.3862 -7.09349 4.4518 -2.20884 -502 1 12.3002 -0.0151335 10.1074 11.0606 -47.8945 -14.4391 -503 2 11.4203 0.251866 10.2671 -34.8312 14.3717 9.25421 -504 2 12.8296 0.729107 10.2725 26.3435 36.9272 6.71278 -505 1 10.377 9.78 12.4264 -19.0889 -11.9366 -11.7107 -506 2 11.0349 9.79085 13.1125 14.2042 0.527855 9.4859 -507 2 10.1856 8.83311 12.286 4.63513 11.4958 0.11243 -508 1 0.612468 2.80552 7.03105 -3.16196 -18.6605 -12.6623 -509 2 0.888173 3.44011 7.68312 3.89236 7.11247 14.3448 -510 2 0.935234 1.94488 7.34043 -2.08916 10.0979 2.30791 -511 1 0.333274 15.3197 6.88029 -14.1577 45.9776 55.0939 -512 2 0.45846 14.8119 7.69617 1.50982 5.91417 -3.14315 -513 2 0.483825 14.7581 6.18064 16.8578 -51.3136 -47.9608 -514 1 17.0479 7.0004 15.1603 7.32733 3.15391 4.0553 -515 2 17.7743 7.62519 15.0492 -4.65368 3.90748 -3.79045 -516 2 17.4843 6.26113 15.5911 -6.30626 -9.6282 -1.63315 -517 1 9.09335 12.4409 8.06571 39.5186 -12.5139 -7.54936 -518 2 9.34597 11.7249 7.45783 10.9221 9.9246 5.15013 -519 2 8.17581 12.4072 7.99758 -53.4732 7.6014 3.58329 -520 1 1.26136 1.81045 2.95361 -2.6705 2.40839 8.80735 -521 2 0.548126 2.01955 2.35817 -5.69651 1.92544 -13.4687 -522 2 1.50342 2.66138 3.33407 8.35517 -3.762 3.05283 -523 1 4.10861 15.1005 9.87028 17.6559 -3.6711 -5.25272 -524 2 3.99986 15.4157 8.96812 -4.49733 0.314881 -1.79245 -525 2 5.04559 14.8362 9.90181 -11.0653 1.71965 6.05025 -526 1 7.3044 2.18074 14.6544 -4.4599 -5.38687 1.90914 -527 2 7.13921 1.65822 13.8561 -1.41133 5.62984 3.30149 -528 2 7.58548 3.05039 14.3636 5.58134 3.87352 -5.39735 -529 1 18.5311 14.6245 2.16796 -28.4168 7.73599 -0.688338 -530 2 0.75601 15.0339 2.21782 2.27339 5.70314 -0.294719 -531 2 17.8249 15.3246 2.17516 22.0369 -13.9852 -0.651534 -532 1 9.98569 2.74939 12.8982 -9.19221 10.3282 12.793 -533 2 9.83979 2.05829 12.2602 3.07064 -9.86428 -11.8695 -534 2 9.16543 3.26718 12.8794 9.24196 0.527571 1.01071 -535 1 2.93657 8.90297 13.0427 17.8365 13.1008 0.527628 -536 2 3.20967 9.8454 12.9227 -4.18066 -20.4527 0.554358 -537 2 3.74278 8.43516 13.3493 -16.2822 5.83343 -3.94486 -538 1 3.21464 8.50963 3.72772 0.0178718 14.8284 -74.1155 -539 2 3.59865 9.33251 3.32895 -6.0017 -25.5341 4.84747 -540 2 3.33657 8.62148 4.62381 5.38554 5.83243 67.2306 -541 1 5.61344 7.20035 8.58446 -2.8239 -8.19112 0.0562215 -542 2 5.53456 6.24006 8.54079 8.61958 1.67382 -4.34837 -543 2 5.04066 7.41711 9.32304 -1.21443 9.5719 0.536432 -544 1 14.8964 1.44105 1.93253 -7.61412 -10.5809 19.4064 -545 2 14.4541 2.19461 2.37874 12.2686 -5.42452 -16.4906 -546 2 15.2548 1.628 1.06483 0.86569 15.045 -4.43663 -547 1 8.4154 15.1546 0.810786 1.70028 1.58395 -11.225 -548 2 9.17382 15.0707 1.40016 -1.99176 -3.13146 6.02583 -549 2 7.70673 14.5929 1.15135 2.54266 -0.476233 4.63029 -550 1 15.567 1.36482 7.20444 28.1778 15.3746 16.2283 -551 2 15.0185 0.765154 6.74682 -23.3742 -21.8939 -17.7163 -552 2 14.9729 1.99808 7.60632 -6.19001 12.1291 -0.330309 -553 1 5.0089 13.0207 18.4853 -18.4609 -5.74542 -15.9738 -554 2 5.42479 13.0864 0.690362 9.95106 2.52519 17.0862 -555 2 5.65544 13.3331 17.8473 1.85993 1.51979 0.712767 -556 1 15.3671 8.54929 18.1095 -8.15636 -15.968 22.0227 -557 2 15.6817 9.03573 17.3686 11.3034 18.5085 -22.2724 -558 2 15.31 9.18561 0.190372 -2.38163 -0.236806 -1.34825 -559 1 12.0802 3.07221 18.3457 4.60183 -13.894 -6.42275 -560 2 12.4859 2.4 0.260392 -4.96838 8.65649 13.1594 -561 2 12.2775 2.7013 17.4791 -3.58827 6.63097 -2.22236 -562 1 13.1993 12.6855 5.15579 5.61247 -4.39703 15.9491 -563 2 13.8115 11.9693 4.94018 -5.07495 0.365899 -6.13845 -564 2 13.2564 12.743 6.12308 -1.32671 2.90452 -5.88021 -565 1 6.08204 7.19061 0.120725 -6.90673 14.7019 -8.65455 -566 2 5.87336 8.13986 -0.0835188 5.89552 -25.7895 13.7146 -567 2 5.2676 6.79179 0.465292 5.04542 5.75855 -0.526985 -568 1 17.7014 15.9063 14.9696 22.6091 -4.25312 7.62853 -569 2 16.8618 16.3646 15.0156 -4.32677 -2.50983 -14.3551 -570 2 17.9392 15.6583 14.0532 -15.4152 10.9643 9.19951 -571 1 13.1673 0.955706 16.6058 -16.4624 13.9879 0.0318296 -572 2 14.0199 0.765403 16.9805 16.2653 -3.85138 1.37902 -573 2 12.7278 0.106773 16.5459 -0.203322 -8.12911 -4.60325 -574 1 10.9967 14.5844 7.33958 -18.0316 -21.646 7.99268 -575 2 10.1705 14.1548 7.70673 29.6081 10.2394 -10.7243 -576 2 11.7328 13.9554 7.47718 -10.5059 7.23567 0.829732 -577 1 17.5629 8.52802 2.09087 -9.01192 -26.3923 -8.78708 -578 2 16.6633 8.41226 2.4486 12.6056 4.50253 0.467713 -579 2 17.6588 7.73531 1.50133 0.834193 24.7006 12.2923 -580 1 12.3809 7.87992 1.9744 6.05515 -15.9846 -5.53898 -581 2 11.7749 8.59773 2.10936 -4.35558 14.0343 4.46215 -582 2 11.9629 7.32605 1.30246 4.89043 0.565697 0.45699 -583 1 11.9793 14.6347 10.4335 18.2405 9.923 28.253 -584 2 12.2756 14.1199 9.71871 15.2703 -21.0335 -29.0838 -585 2 11.0615 14.7405 10.2767 -32.5541 7.66631 -1.56623 -586 1 6.81522 6.956 15.5295 -17.6641 -14.7432 -7.98444 -587 2 7.71149 6.86909 15.2553 24.3623 -4.30517 -12.3513 -588 2 6.87971 7.6292 16.1782 -5.40685 18.4787 21.7047 -589 1 8.03389 4.5887 13.4155 -37.171 -3.64226 -22.5123 -590 2 7.25568 4.78495 12.82 23.9185 -7.87368 18.6792 -591 2 8.43341 5.43391 13.5743 6.319 9.72574 1.79505 -592 1 13.4002 12.1853 14.3374 -4.54681 1.91445 -1.84351 -593 2 13.053 11.3082 14.1695 -1.05297 -9.08012 2.89826 -594 2 13.8525 12.4201 13.5231 2.34057 5.70396 -2.70792 -595 1 14.6576 9.49709 7.25838 9.71531 18.8932 28.1379 -596 2 15.5128 9.94191 7.46983 -15.999 -8.53149 -8.43731 -597 2 14.0596 9.76702 7.98865 8.11873 -7.0154 -18.3951 -598 1 12.7312 16.9238 3.19475 21.2814 -46.1617 -18.4213 -599 2 12.8913 17.1254 4.09275 6.71284 11.8391 31.6773 -600 2 12.0991 17.5238 2.88672 -32.0955 36.7838 -15.6883 -601 1 1.05963 7.10571 17.4007 12.4792 -13.0695 22.2141 -602 2 0.186546 7.34268 17.7101 -8.13154 -6.52047 1.59159 -603 2 1.15324 7.46505 16.5336 -1.37945 14.6986 -20.6467 -604 1 12.8789 5.0234 15.6828 -31.729 4.63914 -0.239626 -605 2 13.551 4.37036 15.6981 25.2388 -22.1242 0.0408259 -606 2 13.353 5.8465 15.7229 6.14669 17.5754 0.411177 -607 1 2.40704 3.36861 5.12193 5.52974 -41.8871 -53.5671 -608 2 1.82145 3.26591 5.8288 -30.6852 -8.64892 41.0269 -609 2 2.78115 4.20498 5.20734 26.4804 50.2953 11.9131 -610 1 8.27515 11.124 13.5771 -2.85187 11.2881 -70.0801 -611 2 8.37295 10.8581 14.431 -1.92558 -15.2628 85.0569 -612 2 8.99363 10.6344 13.1748 6.72692 3.2721 -14.9 -613 1 12.918 1.48119 13.2724 -5.46048 -28.9446 23.2516 -614 2 13.637 1.39783 12.6661 14.6279 -0.945194 -20.1211 -615 2 12.6406 2.36931 13.1901 -10.8983 31.3672 -5.19186 -616 1 6.50945 13.6334 2.15016 9.54562 -3.73103 -23.7728 -617 2 5.85792 13.9589 2.75542 -11.9505 6.96003 17.098 -618 2 7.07728 13.0286 2.63475 0.813075 1.46302 3.43305 -619 1 15.9192 6.52891 12.704 16.1802 17.7634 -8.70325 -620 2 16.3422 7.10874 12.0232 -9.40583 -17.3352 17.4966 -621 2 16.4304 6.67694 13.5293 -11.6709 -4.5663 -12.9766 -622 1 16.8012 0.7168 9.58424 5.37965 28.6432 5.104 -623 2 16.9134 18.4317 9.69441 -4.13374 -28.9785 4.85106 -624 2 16.4797 0.860059 8.69243 -6.31121 -1.15561 -8.50241 -625 1 6.13999 11.6637 8.32406 3.84263 60.0529 3.8669 -626 2 5.34748 11.493 8.80779 -22.31 -6.18549 9.45125 -627 2 6.46273 10.8378 8.08078 19.7827 -51.2376 -16.1138 -628 1 2.82548 8.7059 0.356008 25.1404 7.14145 17.7175 -629 2 2.1872 8.20684 18.5458 -21.47 -27.2684 -27.7438 -630 2 2.28201 9.37487 0.754925 -1.41085 15.0233 10.6798 -631 1 10.1039 10.4509 6.57992 -4.79526 -6.25674 7.70278 -632 2 10.5083 9.74309 7.09516 2.94215 -0.723708 0.948173 -633 2 10.6276 10.5201 5.78606 4.97834 -0.717699 -12.6856 -634 1 6.77313 15.7547 6.63388 -5.578 -17.4503 -5.92282 -635 2 7.15743 16.0375 7.46176 7.11582 8.10879 3.23091 -636 2 7.28529 16.1142 5.89948 -1.84538 11.4125 4.1387 -637 1 6.44197 13.0281 5.69829 11.2984 8.90971 -1.05733 -638 2 6.79679 13.8886 5.97631 -5.91305 -5.55439 0.155281 -639 2 6.12445 12.6032 6.49753 -3.74834 -3.51916 3.00547 -640 1 16.7803 12.5246 9.7433 1.48678 16.9805 10.4147 -641 2 16.9869 12.0132 8.97443 1.49858 -19.0548 -12.8116 -642 2 17.3026 13.3224 9.61445 -4.02823 0.499055 5.20393 -643 1 6.14077 2.94238 2.79674 5.90568 12.9134 -1.15866 -644 2 6.37771 3.87334 2.54509 -6.86675 -27.0997 0.367621 -645 2 5.77601 2.45475 2.03942 1.6023 9.98348 0.439644 -646 1 10.8329 3.18005 3.24633 -5.48645 -3.34604 -3.46544 -647 2 10.1887 3.87164 3.40992 -1.49044 3.74393 4.82403 -648 2 10.5052 2.73309 2.45537 3.4248 -0.0323397 2.60803 -ITEM: TIMESTEP -60 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.78901 6.89398 17.9776 -3.5234 1.93788 3.89787 -2 2 7.91305 7.05712 18.3419 -1.4277 0.241332 2.63834 -3 2 8.67661 6.15674 17.3832 1.3639 -6.15529 -7.04239 -4 1 18.7561 8.31771 6.77309 10.5748 -7.50476 -33.4266 -5 2 0.457617 7.9886 5.89382 -17.7288 16.9324 23.762 -6 2 0.568724 7.76979 7.40723 1.86737 -7.24646 12.6232 -7 1 8.51532 18.7703 6.84705 0.662358 -5.68449 9.56329 -8 2 9.4329 0.211311 6.58737 4.53489 1.21926 -2.36791 -9 2 8.05203 0.803554 6.35578 -1.87482 6.91549 -4.54998 -10 1 6.50103 1.76445 11.707 -23.9337 -6.76257 7.94266 -11 2 5.68898 2.17855 12.0897 23.4576 -7.00878 -10.5629 -12 2 6.21872 0.874053 11.3985 3.54415 20.4784 6.13886 -13 1 7.00577 5.62696 2.40487 20.8008 -18.6778 -13.9491 -14 2 6.3381 5.93149 2.99593 -12.7158 11.2498 18.9927 -15 2 6.96044 6.19487 1.63998 -3.33571 5.44078 -9.1088 -16 1 16.2317 10.2379 16.0906 -2.65398 7.02849 4.45196 -17 2 17.1094 10.623 16.0697 3.52116 -7.47169 -6.62031 -18 2 15.6835 10.996 16.3292 -1.12895 -7.31017 -0.603728 -19 1 10.664 14.9341 2.30567 13.0251 3.56406 6.3158 -20 2 10.7336 14.2976 3.03428 -5.34804 6.23285 -3.50086 -21 2 11.2229 15.6743 2.58509 -4.07292 -1.48419 -0.585019 -22 1 17.1728 8.23947 10.7128 -1.64499 -1.99855 0.608593 -23 2 16.6728 8.84067 11.2819 0.316783 0.889357 -0.63917 -24 2 17.9322 8.74349 10.3965 1.71935 0.329185 -1.07247 -25 1 14.697 15.9473 16.4368 -13.7705 -0.197196 -7.11694 -26 2 13.7879 16.279 16.3001 13.6207 -4.8592 3.02749 -27 2 14.6438 15.4158 17.2461 5.07545 7.5417 -4.99128 -28 1 12.1134 13.367 0.528093 -6.39608 9.01831 -4.72995 -29 2 11.8173 13.4954 18.2644 6.74141 -8.66363 -5.87361 -30 2 11.5587 13.987 1.01769 3.38254 -3.71164 8.60635 -31 1 9.30318 5.47999 3.94883 35.8178 1.45581 -2.5285 -32 2 8.76671 5.2044 4.67379 -16.9173 -4.15595 18.9992 -33 2 8.71572 5.58687 3.21666 -20.2172 1.55363 -14.8227 -34 1 1.70529 4.08306 11.601 -3.00308 -9.11056 -2.97947 -35 2 1.52513 4.97184 11.9147 2.37337 9.05749 0.600173 -36 2 2.22567 3.63839 12.2786 -1.82607 -0.283286 1.9059 -37 1 2.04499 6.82744 8.26893 9.18028 14.0429 7.96475 -38 2 2.5896 7.29904 8.93262 -11.3816 -6.25496 -6.31442 -39 2 1.81536 5.98181 8.67357 4.33854 0.450625 -3.71013 -40 1 5.3656 4.4774 7.93824 1.44041 9.72132 7.59831 -41 2 5.44269 3.52851 7.84762 -1.19648 -12.0175 -6.62376 -42 2 4.92598 4.83778 7.16432 -9.0894 -3.97332 -7.9273 -43 1 3.32251 2.9413 17.4443 0.538374 -34.3486 -6.77872 -44 2 3.98642 3.24962 16.8336 8.9197 7.73227 -3.39959 -45 2 3.04976 3.68399 17.9526 -12.2781 23.4468 13.5982 -46 1 7.437 5.38423 6.13063 5.01567 -0.272219 -26.6536 -47 2 7.97737 5.94965 6.66546 10.8347 10.076 12.8667 -48 2 6.99068 4.78917 6.71033 -9.3836 -11.0864 17.8628 -49 1 9.80479 7.01238 12.0379 -9.46641 4.39554 -21.4508 -50 2 10.3276 6.40912 11.4906 -4.30802 3.34771 7.14548 -51 2 9.13044 7.38666 11.4225 10.4612 -8.54147 15.485 -52 1 14.0024 3.65677 8.07153 1.90613 10.1899 13.6881 -53 2 13.9361 4.48059 7.56554 -1.4656 -7.0627 2.39316 -54 2 14.1946 3.93561 8.9889 0.417494 -3.38136 -15.0381 -55 1 4.51888 17.1453 3.95588 7.87944 -4.67708 3.20643 -56 2 5.41436 17.4585 3.90856 16.3959 1.38908 8.05638 -57 2 4.13204 17.4705 3.15493 -16.1768 7.51082 -11.5461 -58 1 16.4506 16.6012 10.3314 -28.9812 -6.12917 4.01051 -59 2 15.5905 16.5574 10.8183 20.4446 2.48532 -11.9951 -60 2 16.2667 16.1387 9.49338 0.364513 2.67256 9.91326 -61 1 1.97065 4.79938 0.260671 -8.10245 -17.5737 -13.0373 -62 2 2.41281 5.12274 1.03667 10.218 10.6244 9.40508 -63 2 1.8267 5.54768 -0.321227 -3.59337 9.6389 -0.147197 -64 1 11.5035 13.2586 16.3577 -0.713967 20.2415 12.8794 -65 2 11.0441 12.4305 16.4814 -6.19498 -9.28579 -2.23027 -66 2 12.0754 13.1484 15.6021 5.65191 -4.41955 -9.63321 -67 1 10.1276 11.0105 16.8449 -6.46201 16.5427 1.83518 -68 2 10.5556 10.1721 16.794 12.0656 -22.7421 -1.13044 -69 2 9.20289 10.8171 16.6996 -9.212 1.56961 -0.130134 -70 1 11.787 17.4505 13.4822 -3.74088 11.88 -4.97071 -71 2 12.2373 16.9277 12.8063 6.56705 3.4706 4.72845 -72 2 12.0251 18.3805 13.3063 -1.30808 -7.68873 2.97322 -73 1 6.42132 9.37259 12.2366 13.1698 8.24141 3.19081 -74 2 6.99069 9.01867 11.5406 -12.3498 -0.982732 4.41902 -75 2 7.03807 9.88277 12.7853 -8.70879 -2.27031 0.0855326 -76 1 16.2815 12.8722 2.70224 -2.02351 7.50879 0.830271 -77 2 17.1172 13.3658 2.56775 -16.1548 -5.18742 1.80773 -78 2 15.5334 13.5108 2.69253 18.3367 -6.33955 1.64103 -79 1 0.729913 12.6587 5.89268 5.90957 5.27776 3.54404 -80 2 1.01336 12.4973 4.99287 4.32656 -0.558571 -7.43154 -81 2 18.4322 12.7877 5.81211 -15.2269 -3.44557 0.704235 -82 1 5.2582 16.4249 18.4194 -10.384 10.1199 -1.35479 -83 2 5.6864 15.6785 18.0038 6.48963 -9.24773 3.62069 -84 2 5.52942 16.4885 0.694307 6.00107 -3.50652 -0.438993 -85 1 0.618748 7.72132 4.16911 -57.0293 -28.7954 36.7096 -86 2 18.6577 8.06272 3.52122 -10.6934 7.30065 -13.2418 -87 2 1.44908 7.88182 3.83946 68.942 18.8036 -26.9673 -88 1 3.13476 8.97804 6.4725 9.50813 11.9402 -13.0637 -89 2 3.74054 8.49646 7.01761 11.8689 -6.06991 10.2621 -90 2 2.28514 8.86225 6.86989 -19.244 -2.30506 4.89646 -91 1 7.29998 10.3842 16.2581 17.8205 -0.109318 -17.8263 -92 2 6.62843 10.5749 15.608 -5.58859 2.04705 -1.34953 -93 2 6.87201 10.3756 17.1052 -6.43011 -2.48695 12.6131 -94 1 11.0863 0.954938 5.00203 0.851153 5.26347 3.05665 -95 2 11.191 1.83687 4.62341 -3.02583 0.75042 -0.451702 -96 2 10.8235 0.406956 4.25776 -2.05383 -4.79736 -1.16032 -97 1 4.33613 2.85707 13.1911 1.54519 27.1095 -5.33994 -98 2 4.57692 3.1724 14.0657 0.352889 6.79614 0.336856 -99 2 4.2364 1.93118 13.308 -7.70759 -34.1778 4.58716 -100 1 8.4203 10.2079 1.80876 2.06346 -1.14808 -20.454 -101 2 8.303 10.9031 2.4489 -3.41662 7.51624 10.9075 -102 2 8.71506 9.44854 2.30018 2.97787 -12.0816 9.03727 -103 1 10.3977 1.70625 15.5267 1.73644 2.79304 1.06494 -104 2 11.3647 1.6343 15.5026 -8.09264 -2.44943 -3.11689 -105 2 10.0867 1.93234 14.6348 6.55478 -0.658466 2.12488 -106 1 2.65181 12.9273 7.85805 -0.311785 2.06689 -1.07798 -107 2 3.23228 13.5447 7.39928 3.74905 0.741997 1.40009 -108 2 1.98379 12.6968 7.20259 -0.999427 -0.794231 1.07688 -109 1 3.77953 11.641 5.00453 4.18201 7.36008 7.19136 -110 2 3.61117 10.803 5.43181 -1.00449 -4.29555 7.12479 -111 2 2.98088 11.8656 4.52857 -4.84381 -0.0516249 -5.594 -112 1 6.70671 14.4383 16.9441 -2.88793 7.65462 4.66357 -113 2 7.46032 14.9632 17.2378 1.25427 -2.15328 -4.6823 -114 2 6.29331 14.8741 16.1864 7.83964 -2.53039 -3.71142 -115 1 14.1974 14.5272 3.32557 -8.64957 0.126228 1.77541 -116 2 13.6145 15.2324 2.99689 6.18241 -4.15847 9.95625 -117 2 13.7792 14.1343 4.11346 2.7139 4.36583 -10.9531 -118 1 8.49626 18.0895 16.0579 -56.9361 5.6973 -1.31016 -119 2 8.97799 17.2887 16.1101 31.3098 -20.0295 7.70991 -120 2 8.99116 0.248943 16.0582 28.7181 13.2998 -3.6499 -121 1 4.72072 1.70195 4.90499 9.17194 -24.9679 14.1726 -122 2 3.98364 2.22531 5.16555 -23.8501 10.7625 5.04957 -123 2 5.10611 2.17516 4.19081 15.0133 13.348 -19.3674 -124 1 15.0233 12.5839 16.4881 -18.3113 17.2758 -0.569629 -125 2 14.531 13.0978 17.1312 10.6463 -2.17552 11.3526 -126 2 14.3728 12.5238 15.7796 8.99848 -7.00837 -8.88439 -127 1 15.6995 18.4783 16.8755 -18.8856 10.9503 -24.4051 -128 2 16.4938 18.4127 17.3644 26.3461 0.942046 24.9737 -129 2 15.418 17.5728 16.7613 -4.49112 -11.2036 -1.17338 -130 1 1.28835 1.23059 16.5761 -5.93248 -0.138309 0.14802 -131 2 2.13994 1.64325 16.7078 7.79309 6.58334 -0.470261 -132 2 0.740967 1.66098 17.2372 -5.253 -1.12337 3.85618 -133 1 18.1629 4.44327 15.9115 -6.79632 -1.27318 -1.28488 -134 2 18.1308 3.86521 15.1462 0.0573414 -0.0912133 -1.44422 -135 2 0.437875 4.54116 16.1499 5.78898 1.89854 1.50737 -136 1 12.2373 17.0002 16.1546 0.545523 9.79929 -13.3931 -137 2 11.4461 16.6427 16.5433 -11.0844 -6.7728 9.10484 -138 2 12.011 17.1373 15.2222 3.0182 -2.09591 3.06353 -139 1 16.0678 2.55904 18.1722 10.2246 -6.29614 14.7907 -140 2 15.8342 3.46829 18.3235 -8.81825 14.1289 4.59946 -141 2 15.8732 2.39245 17.2622 -4.4601 -2.08833 -19.809 -142 1 6.72425 13.805 10.1648 -2.60578 6.66979 -6.33116 -143 2 6.49371 13.5045 11.0525 -0.564993 -6.25943 -2.37403 -144 2 6.44263 13.1457 9.51237 3.71898 -2.3263 8.04067 -145 1 10.1796 18.3897 2.72456 -2.84724 -9.82946 6.47371 -146 2 10.454 0.395639 2.08514 4.83004 8.04726 -9.16723 -147 2 9.37175 18.0281 2.35385 -6.15379 0.681222 3.71385 -148 1 3.03584 17.7169 6.12875 -8.09623 -9.32203 -7.45056 -149 2 2.18289 17.4189 5.74043 17.1828 11.6191 3.33552 -150 2 3.689 17.6882 5.40781 -11.2408 2.0569 5.59443 -151 1 12.6056 16.8615 7.96971 24.61 3.09247 -20.49 -152 2 12.0094 16.1192 7.91607 -18.906 -3.75998 3.49802 -153 2 12.4208 17.4479 8.69718 -9.87831 1.59818 13.2946 -154 1 14.8851 15.258 8.17849 4.86996 1.69705 3.53461 -155 2 13.9994 15.6489 8.25275 11.2692 6.96129 -5.86816 -156 2 15.346 15.6481 7.40987 -12.7499 -9.2219 7.50011 -157 1 17.7579 18.2305 0.335063 13.8809 -6.66068 -7.77561 -158 2 18.5388 17.6427 0.115787 -18.9695 29.962 7.44433 -159 2 18.0215 0.522838 0.460167 3.90753 -19.2563 -2.82208 -160 1 0.789759 10.4825 1.35847 3.51968 14.2812 -7.72333 -161 2 0.0798625 9.88631 1.6077 -6.45512 -1.46576 0.207918 -162 2 0.407025 11.2033 0.810215 7.48025 -15.8311 11.8414 -163 1 1.75759 12.251 3.36651 -3.2997 0.800224 -5.24767 -164 2 1.53389 11.5715 2.69671 0.947411 14.52 5.02147 -165 2 1.90006 13.112 2.93145 -3.03991 -14.1386 -4.6936 -166 1 0.626528 17.2392 4.94747 0.535799 -10.8391 4.53682 -167 2 18.8821 18.137 4.96158 -2.27873 -17.8214 11.6149 -168 2 0.354378 16.6324 5.68648 2.97307 28.5848 -17.7586 -169 1 1.10952 0.863641 9.39152 -13.7339 -4.40866 12.9037 -170 2 1.31873 0.587529 10.3088 -1.45288 2.90017 -16.0983 -171 2 0.209028 0.525909 9.24512 10.3392 4.25606 -0.349363 -172 1 16.7392 2.34887 13.3076 6.86896 9.31967 14.159 -173 2 16.9447 2.54868 12.3949 -1.60073 1.25233 -7.99088 -174 2 16.5723 1.40956 13.3727 -4.20045 -10.3799 -4.26178 -175 1 2.67499 15.8791 12.0838 -15.6649 13.6026 18.6328 -176 2 3.08767 15.4473 12.8331 1.25238 -1.62775 -1.314 -177 2 3.09072 15.5563 11.2931 8.09534 -6.35014 -12.1736 -178 1 16.4274 15.6453 6.10859 -17.0431 -16.804 0.948824 -179 2 17.3058 15.6768 6.44562 21.0308 -4.79075 10.9 -180 2 16.4023 16.3397 5.46924 -8.03031 15.1286 -15.2988 -181 1 5.80151 5.1106 11.8034 -9.99749 12.6805 7.50019 -182 2 5.41461 5.91177 12.2246 6.41162 -14.9692 -6.22456 -183 2 5.12172 4.42339 11.8362 4.25931 3.80702 2.95737 -184 1 15.1575 4.86793 0.802761 22.7174 4.42582 -27.0135 -185 2 14.9254 4.50834 1.64009 -5.31496 -5.26411 26.4075 -186 2 14.3858 5.30472 0.469017 -12.1413 5.82456 -3.82743 -187 1 16.3769 16.3844 2.01422 -5.72057 14.22 1.10565 -188 2 15.9278 16.7493 2.80314 10.8683 -6.01604 -9.24812 -189 2 16.773 17.1531 1.56448 -5.22082 -7.76197 3.40899 -190 1 0.23965 4.83003 3.84895 -16.8427 -30.7507 -16.2196 -191 2 0.252698 5.75131 3.99923 2.34384 38.0203 4.84997 -192 2 0.859131 4.45396 4.45569 14.7994 -7.19156 9.40612 -193 1 2.95205 15.0559 15.135 12.255 2.89982 -34.0079 -194 2 2.82691 14.77 16.0276 -6.33331 -2.96333 21.8089 -195 2 2.70057 15.9867 15.0833 -9.42631 -1.00353 7.2626 -196 1 1.12786 14.6523 9.50314 0.137917 -12.6668 4.07712 -197 2 1.90226 14.1941 9.14772 -4.18616 2.58129 -2.64264 -198 2 0.826039 14.044 10.1958 0.138103 8.11094 -6.03497 -199 1 13.5191 16.5585 11.5327 7.73147 -8.17374 8.97592 -200 2 13.1298 17.2703 11.0385 -2.21772 17.726 -8.86187 -201 2 13.0359 15.7976 11.2032 2.83922 -8.38127 -1.58332 -202 1 4.66669 1.44213 0.750789 16.1276 9.43437 -4.32571 -203 2 4.14083 2.03292 0.213208 -5.20243 5.56453 -6.36037 -204 2 4.0469 0.85314 1.17877 -1.04658 -3.40534 3.74731 -205 1 1.47829 18.5621 11.858 5.51121 1.25702 19.3245 -206 2 1.35114 0.550992 12.5892 2.53269 -8.70306 -5.34898 -207 2 2.06733 17.8728 12.2103 -6.7512 4.69931 -6.32602 -208 1 11.4685 10.1386 3.99675 -31.6511 -19.8648 40.1611 -209 2 11.3534 10.4173 3.11507 -1.88937 16.5167 -32.0622 -210 2 12.3922 10.1317 4.15588 31.92 0.339396 6.83567 -211 1 8.2329 12.185 3.6562 14.6677 -4.21505 -16.0366 -212 2 9.0609 12.5679 3.94713 7.11932 4.3628 2.52934 -213 2 7.63223 12.3212 4.36927 -17.6963 1.05811 24.4992 -214 1 14.5368 4.0151 3.29112 -13.123 -7.80297 -23.8392 -215 2 15.0981 3.94713 4.04639 13.729 3.5857 20.4451 -216 2 13.7669 4.51912 3.55347 -6.0046 4.6829 5.42155 -217 1 5.65486 1.65777 7.52148 58.4475 40.9395 -13.9317 -218 2 4.99661 1.25201 7.99959 -53.8788 -37.1346 38.2946 -219 2 5.51095 1.40377 6.61889 -5.49301 1.61126 -19.8188 -220 1 17.8901 1.045 4.84749 -9.94718 -16.9222 0.488244 -221 2 18.5122 1.52388 4.30334 5.34684 7.49098 -3.2278 -222 2 17.6047 1.57034 5.59464 4.63979 8.2364 3.24002 -223 1 6.81309 9.39039 4.50819 3.0131 -8.49785 6.19054 -224 2 6.80308 9.57416 5.46384 1.81054 -3.72037 -9.62081 -225 2 7.68859 9.02244 4.29465 -5.74329 4.97879 4.89484 -226 1 2.5752 14.8387 1.99973 -14.8295 0.871449 -1.75437 -227 2 3.26878 14.7632 2.65166 10.803 -1.54702 2.65568 -228 2 2.97003 14.8559 1.12279 1.99123 -2.02101 2.0261 -229 1 17.298 12.9204 13.1492 -3.4846 16.1956 -6.51124 -230 2 16.423 13.308 13.3278 8.68723 -6.18077 0.438899 -231 2 17.8438 13.7012 12.9334 -6.61166 -12.0077 2.21466 -232 1 14.9034 10.5534 1.40093 -1.35277 29.2651 19.5565 -233 2 15.388 11.3453 1.77149 -13.4573 -26.0533 -12.1606 -234 2 13.9634 10.6773 1.62965 16.0361 -2.08776 -5.28169 -235 1 5.72986 6.65162 4.58435 -17.0557 15.5593 -6.14164 -236 2 5.84842 7.61417 4.55049 3.33824 -4.32419 -0.681988 -237 2 6.28697 6.32726 5.29234 8.09232 -2.61709 -0.816212 -238 1 7.99944 8.35521 10.3848 17.9936 -2.63811 -6.27588 -239 2 8.59251 9.07404 10.0893 -6.48701 -11.154 -5.32581 -240 2 7.88909 7.71789 9.66296 -2.42609 11.6503 -0.200638 -241 1 13.4241 18.44 5.69275 23.5538 0.0525075 -9.71433 -242 2 12.6953 0.391603 5.53139 -12.0458 3.72648 -1.32391 -243 2 13.2482 18.017 6.52624 -8.74326 -11.7295 10.7578 -244 1 0.0158155 2.64508 0.27395 14.5716 -58.678 15.8132 -245 2 17.7841 2.79898 -0.0392974 -21.1138 14.4347 -10.6776 -246 2 0.56739 3.397 0.238244 13.7063 38.8805 -4.38724 -247 1 12.8888 11.0203 9.74081 14.4921 -25.5472 6.65601 -248 2 11.9442 11.0265 9.60333 -9.9467 -3.56544 -1.05488 -249 2 13.1018 10.1085 10.0646 -8.85698 19.3484 -7.35591 -250 1 0.676749 12.1402 11.0769 -15.7222 13.4662 19.3247 -251 2 18.361 12.1632 11.2371 5.51909 -2.16069 -8.49445 -252 2 1.03381 12.419 11.9274 8.68848 0.134808 -1.80861 -253 1 5.1281 7.32638 13.4074 12.574 7.81643 0.126088 -254 2 5.56178 8.11083 13.0117 -0.574951 -12.9077 2.36295 -255 2 5.67541 7.10745 14.1812 -7.25639 3.83801 -6.5213 -256 1 1.19691 6.83481 11.9192 5.63437 23.0857 0.0567084 -257 2 0.430704 7.22717 11.4609 12.0202 -4.44614 6.83847 -258 2 1.80476 7.59103 12.1282 -18.5438 -19.7012 -5.0003 -259 1 15.5112 9.6605 12.308 7.39931 -23.3592 2.14975 -260 2 15.3284 10.5626 12.1388 -11.1565 28.2269 -10.7029 -261 2 15.46 9.608 13.2546 2.72926 -7.26454 12.4411 -262 1 16.5981 12.7055 5.55132 5.93792 -6.99565 4.13948 -263 2 16.3871 13.6216 5.72312 -3.40713 11.8574 1.85996 -264 2 16.4508 12.5854 4.61105 -1.1211 0.407027 -8.19974 -265 1 6.341 9.80883 0.0188309 -5.87145 18.2236 11.3739 -266 2 5.58583 10.3592 0.271383 3.51693 -3.70717 1.01998 -267 2 6.97723 9.90576 0.746734 -2.19026 0.0209431 -7.09875 -268 1 12.2976 6.11648 4.05009 -7.99316 6.14403 -18.1211 -269 2 12.258 6.83685 3.38221 3.50754 -15.1435 11.6411 -270 2 11.4736 5.62673 3.91242 4.22123 1.1153 4.56647 -271 1 0.341758 12.8367 0.152932 -4.41368 -4.71323 -6.18075 -272 2 -0.071293 13.3938 0.818389 4.38543 6.64898 2.3316 -273 2 18.4831 12.9746 17.9873 -4.56942 3.87447 -1.94524 -274 1 3.61813 18.6313 8.61443 0.661139 8.76689 2.03667 -275 2 3.46056 18.3752 7.69711 -0.554223 -6.30588 2.24303 -276 2 2.77043 0.354615 8.90695 5.13325 -4.08936 -2.3138 -277 1 7.42355 17.3409 4.4768 -7.56741 1.42105 -0.716546 -278 2 7.51902 18.2689 4.68925 3.30463 5.13228 6.51734 -279 2 7.58206 17.32 3.5353 -0.521854 -4.80047 -8.50069 -280 1 9.24832 17.1301 12.2139 -13.1815 7.8308 -4.22869 -281 2 9.33905 16.301 11.7591 -2.0028 -14.1862 -9.75618 -282 2 10.0447 17.2202 12.718 16.3553 3.99578 13.5609 -283 1 13.2894 13.0415 8.03267 8.35671 10.0486 -9.41069 -284 2 13.3695 12.1786 8.4589 5.84428 6.69767 4.94138 -285 2 14.1604 13.5085 8.0433 -18.6948 -10.3528 3.9365 -286 1 14.8481 2.99092 15.3927 0.856118 4.40098 19.7153 -287 2 14.1706 2.3196 15.3374 -5.14829 -8.82459 -5.54141 -288 2 15.3789 2.92995 14.603 5.00888 -0.952448 -11.2281 -289 1 9.90287 15.5907 16.9887 3.86064 7.54266 0.708681 -290 2 10.4376 14.8321 16.7196 -3.05759 -5.14225 0.11478 -291 2 9.69704 15.4836 17.9287 -2.19155 -3.5869 -5.21272 -292 1 11.3068 8.44228 16.6046 -8.18504 -5.87812 -2.49231 -293 2 10.7375 7.86962 16.0559 4.371 7.7216 8.33293 -294 2 11.2933 8.06373 17.4959 1.16379 -1.60832 -8.83864 -295 1 4.00007 18.2264 16.7774 4.24494 10.2639 17.5421 -296 2 4.56172 17.6396 17.2965 -1.57319 -6.32646 -5.9019 -297 2 3.85664 0.302165 17.4089 -1.12143 -0.586814 -11.7526 -298 1 2.2479 4.22742 8.91978 -15.7964 -0.236851 -9.315 -299 2 3.17417 4.26053 8.71033 14.3134 -0.385935 -1.23962 -300 2 2.16897 4.01078 9.84529 1.80454 -0.809508 12.1296 -301 1 9.87751 10.3883 9.74788 10.9603 -30.3507 -6.41167 -302 2 9.55849 11.2198 9.44401 -12.062 25.9436 -6.06801 -303 2 10.0779 10.4258 10.6774 1.92757 5.46095 17.7276 -304 1 9.69765 0.927205 10.8701 14.9831 -0.992619 -3.75191 -305 2 9.43595 0.039964 11.1566 -10.0783 4.56951 -4.94264 -306 2 9.12787 1.25731 10.1583 -1.53115 -8.98556 4.28196 -307 1 9.19006 15.088 10.2066 22.8811 13.4843 7.03893 -308 2 8.82905 15.9231 9.90375 -5.23887 5.212 -7.88342 -309 2 8.4517 14.4971 10.2333 -16.9878 -12.2258 -0.936878 -310 1 0.910091 9.64474 10.2618 6.35784 -25.2235 -17.0921 -311 2 0.848571 10.4636 10.7331 2.68282 16.4495 1.28733 -312 2 1.6853 9.71195 9.67503 -11.8234 -0.16557 12.5577 -313 1 17.0493 4.85425 8.1315 23.124 -12.0189 -22.071 -314 2 16.5036 5.57379 8.38464 -19.6085 19.0848 9.20549 -315 2 17.0051 4.2127 8.82658 -1.69519 -7.20825 12.6053 -316 1 14.7684 14.7087 0.123438 -2.69691 -12.5371 -11.3918 -317 2 15.061 15.3506 0.758659 10.1685 10.0196 13.4831 -318 2 13.9556 14.337 0.462955 -8.28455 -4.39651 5.72223 -319 1 3.75153 11.0481 9.53582 4.71209 -10.2499 1.98044 -320 2 3.63189 11.3357 10.4456 -0.734234 5.70871 5.17654 -321 2 3.24354 11.632 8.96907 -2.43681 8.8531 -2.47663 -322 1 11.2519 10.7463 1.5017 8.48932 -12.5201 -0.266865 -323 2 11.5908 11.5519 1.12329 1.64528 14.0457 -7.10687 -324 2 10.3311 10.688 1.26079 -12.3399 1.77059 -3.9568 -325 1 13.1496 7.17281 12.6854 5.50111 -7.8338 2.87732 -326 2 14.101 6.95885 12.7444 -10.2033 1.82309 -0.47089 -327 2 12.6663 6.34751 12.851 5.63542 3.55 -1.50526 -328 1 9.61828 1.90104 0.967862 -1.73511 6.80555 -16.7575 -329 2 8.75126 1.82608 0.511852 18.7109 -2.38487 5.6602 -330 2 10.2637 2.29933 0.349253 -13.3131 -4.11214 4.99441 -331 1 10.6435 13.4896 4.54607 -8.3754 1.2658 -1.96254 -332 2 11.4795 13.0515 4.69791 8.28938 -6.58305 0.731496 -333 2 10.5798 14.1432 5.24738 -1.32643 -0.553656 5.74704 -334 1 14.4543 1.71115 10.9546 -7.69161 -4.81009 -3.91494 -335 2 15.2136 1.28396 10.5547 4.80162 -2.13195 -1.67599 -336 2 14.6015 2.65135 10.8079 -1.60778 0.935868 6.54178 -337 1 14.5384 12.1186 11.6682 4.42158 0.0609916 50.1985 -338 2 15.3244 12.3738 11.2188 19.3883 10.0258 -22.7848 -339 2 13.838 12.0043 11.0592 -19.2299 -5.1918 -28.9193 -340 1 8.19636 5.07775 9.81895 6.92668 -2.08004 -5.22277 -341 2 7.38544 5.24812 10.3055 -3.33886 -3.05544 1.61921 -342 2 8.19204 4.12852 9.59915 -2.53054 10.0553 1.98192 -343 1 1.48663 16.8897 18.439 7.38955 -7.44055 -8.00122 -344 2 1.97341 17.2271 17.6702 -6.10601 -1.16576 3.12224 -345 2 1.43805 15.9298 18.2902 4.85843 10.0488 4.15854 -346 1 1.49392 17.3013 15.324 -13.7543 10.7593 4.06087 -347 2 1.44447 18.24 15.6259 -3.67575 -24.1287 -4.86768 -348 2 0.590882 16.9129 15.3122 14.6177 13.551 2.26757 -349 1 3.61646 5.75696 6.06482 3.05275 -16.2413 -2.75756 -350 2 3.17 6.32551 6.68313 -10.4039 6.81614 9.87761 -351 2 4.1613 6.3181 5.51248 5.12466 2.54076 -5.58469 -352 1 12.4579 9.47416 14.2028 -15.1686 39.1263 4.59508 -353 2 12.91 8.74193 13.8564 21.0065 -34.4741 -21.4004 -354 2 12.311 9.21984 15.1046 -5.21536 -3.05923 17.073 -355 1 4.05954 15.2722 6.9713 -12.2847 -13.6907 9.03639 -356 2 3.52733 16.0267 6.71946 -3.69787 8.1984 -1.38185 -357 2 4.94462 15.4979 6.70957 17.3953 3.39893 0.124931 -358 1 0.676716 8.64845 15.0435 0.0448789 -8.8726 2.29819 -359 2 0.388517 9.55355 15.1457 -0.102902 11.258 0.0552156 -360 2 1.38121 8.67263 14.3922 3.78483 -0.0353447 -4.44966 -361 1 12.9131 8.29224 10.2146 2.07907 -10.3878 2.68575 -362 2 13.6346 7.78925 9.80195 -2.79275 5.95566 3.91371 -363 2 12.8029 7.87463 11.0885 3.60602 9.09063 -7.955 -364 1 15.3505 7.77425 3.51602 -25.105 2.18251 -0.815364 -365 2 14.4666 7.51634 3.2857 -7.66712 2.41401 -31.383 -366 2 15.2516 7.5997 4.43625 29.5189 -3.75051 28.1293 -367 1 17.2908 6.71242 0.0288264 8.4359 -0.0595562 3.38218 -368 2 16.7481 6.02838 0.414195 -4.41494 -10.5616 1.77026 -369 2 16.6696 7.39667 18.4317 -9.71571 9.06541 -4.14994 -370 1 8.93558 6.94317 7.77066 11.3734 11.9101 1.30985 -371 2 9.8513 7.28708 7.82315 -13.5624 -4.9569 -0.419932 -372 2 8.83457 6.3282 8.49913 -0.351333 -9.82053 6.39411 -373 1 12.3886 0.605922 1.26733 4.3474 1.63423 -5.64369 -374 2 13.3496 0.62067 1.39833 -3.50709 5.26207 -1.10414 -375 2 12.2365 0.554465 0.317002 3.44844 -5.08055 2.164 -376 1 5.6093 15.1332 14.5298 5.50237 -6.63524 -3.85361 -377 2 4.67729 15.3131 14.6547 -7.5977 -3.56809 4.17708 -378 2 5.99198 15.9265 14.1501 5.33744 7.17763 0.920224 -379 1 3.83862 6.42399 1.72255 -0.530245 0.761181 6.81888 -380 2 3.42185 7.23588 1.41886 -3.5948 7.2146 -3.68667 -381 2 3.94102 6.55655 2.67261 0.00170673 0.796504 -2.59346 -382 1 3.90756 11.5263 12.3817 0.20855 -7.47029 -8.65749 -383 2 4.79535 11.8927 12.4625 -0.681042 -1.53834 0.918823 -384 2 3.33577 12.1179 12.8713 -4.93373 1.57702 0.731635 -385 1 5.31593 3.88159 15.8542 -0.71358 -42.6288 -12.177 -386 2 5.97198 3.22378 15.5406 -6.31298 7.40988 7.32158 -387 2 5.73536 4.71214 15.7787 14.3185 32.9857 -0.935745 -388 1 14.2562 10.2258 4.56557 -18.8652 24.4894 6.04548 -389 2 14.4389 9.92543 5.45169 -1.13053 -5.88778 11.8213 -390 2 14.6954 9.63367 3.98806 17.1426 -20.2086 -20.2139 -391 1 7.6892 17.381 9.10447 19.4711 -25.2283 0.682627 -392 2 6.86971 17.6207 9.51632 -14.1206 10.5396 4.24559 -393 2 7.90224 17.9622 8.37374 -3.5427 12.2774 -4.18627 -394 1 4.51373 14.5018 3.89084 0.522587 -13.0056 -37.966 -395 2 4.5996 15.4052 4.14706 0.258928 20.2029 10.6105 -396 2 4.49773 13.963 4.65868 1.58881 -14.8294 26.2191 -397 1 14.2556 7.39762 15.8429 -9.24001 -8.17606 -10.1746 -398 2 15.1854 7.31956 15.6389 10.3704 -1.38951 -4.38862 -399 2 14.2355 7.83779 16.6857 -0.295639 4.56275 12.5602 -400 1 3.05453 18.3862 1.94671 -28.337 -27.777 -22.0693 -401 2 2.58101 17.7651 1.32015 15.7039 17.8808 20.6311 -402 2 2.35293 0.259745 2.36363 3.01847 1.93426 2.5363 -403 1 7.98344 1.63895 4.58298 -1.95289 -5.65456 5.83277 -404 2 7.39472 2.00993 3.91227 5.60846 -0.877805 -3.34347 -405 2 8.83104 1.39808 4.18815 -5.23209 5.3786 -4.6966 -406 1 2.44155 14.16 17.683 19.8901 20.6744 -11.1998 -407 2 1.71949 13.6284 17.9614 -19.7639 -16.6874 11.6615 -408 2 3.22651 13.6749 17.9404 10.3416 -4.56611 4.09925 -409 1 0.874431 1.8172 13.9017 -2.66591 2.98819 0.0720706 -410 2 0.796895 1.67216 14.8604 0.805718 -0.9226 -9.7327 -411 2 18.6311 1.96655 13.5402 2.6832 0.103556 9.2189 -412 1 4.40474 18.7103 13.8903 -4.51489 2.73844 -3.11833 -413 2 5.26066 18.332 13.6843 10.2731 -0.629088 3.90858 -414 2 4.27285 18.5624 14.8326 -2.10334 -1.04281 2.89108 -415 1 7.22541 0.768378 18.3802 -7.41292 5.22253 -10.0414 -416 2 7.14919 0.357851 17.5011 6.06274 3.8916 10.097 -417 2 6.39657 1.25171 18.5223 1.70256 -10.1891 2.75464 -418 1 16.0038 18.3833 13.9769 4.60778 -2.90009 -16.1733 -419 2 15.0678 18.3553 13.7682 -2.12799 2.80836 4.60244 -420 2 16.1189 18.6995 14.8699 -6.8859 -1.5785 15.9997 -421 1 10.1619 4.59436 16.2508 34.7775 -10.6887 1.26028 -422 2 11.1678 4.58362 16.2281 -36.3206 4.79489 -1.20103 -423 2 9.8959 3.67942 16.0718 3.3051 4.94693 0.644026 -424 1 15.9268 17.7185 4.48585 -0.443376 -19.9814 -7.77196 -425 2 16.5546 -0.221465 4.56619 12.2284 16.6263 -2.03126 -426 2 15.0862 18.0786 4.73637 -15.899 7.019 6.15678 -427 1 6.9987 17.4508 13.864 -28.5259 -4.03497 -9.84039 -428 2 7.52153 17.7102 14.6061 10.1765 7.77338 18.9538 -429 2 7.63162 17.2858 13.1766 11.9873 -1.11294 -13.1093 -430 1 13.256 6.47431 6.57718 13.0919 -2.27803 2.33044 -431 2 14.2181 6.68617 6.52776 -23.2683 -1.75779 -6.09518 -432 2 12.9031 6.34478 5.6793 8.47748 2.51219 6.97161 -433 1 7.82324 2.30197 9.35649 6.58131 4.23212 14.3466 -434 2 7.32826 2.17284 10.185 -1.16662 2.6949 -8.43976 -435 2 7.24342 2.0875 8.62812 -8.03625 -5.88123 -5.84644 -436 1 15.1686 14.8419 13.6961 6.6084 -8.9126 -6.67367 -437 2 14.8499 15.0658 14.5674 -3.29174 5.55862 10.3748 -438 2 14.9102 15.5355 13.091 -7.311 3.85237 -1.87114 -439 1 9.39203 8.3247 3.79765 -11.0731 4.19637 -5.3616 -440 2 10.2213 8.76913 3.95172 10.5135 8.75123 3.89829 -441 2 9.56922 7.39926 3.9554 -1.92777 -9.54221 1.11885 -442 1 17.7628 13.6056 16.4368 0.454101 -14.0132 9.10192 -443 2 16.8123 13.4442 16.4542 -1.43638 -1.23592 -2.30674 -444 2 17.8812 14.4042 15.9249 -1.89469 7.90276 -3.85648 -445 1 4.90818 10.546 2.83916 0.136377 -2.73925 -10.4847 -446 2 5.60998 10.1288 3.34488 4.96678 -0.616571 0.115447 -447 2 4.51664 11.1769 3.44738 0.912314 1.46625 2.09919 -448 1 3.71104 8.38719 10.068 0.753133 0.0228827 -3.76935 -449 2 3.89927 9.29887 9.80067 -2.70003 -3.09285 3.15772 -450 2 3.67512 8.396 11.0298 -2.24059 1.87779 0.37074 -451 1 15.9565 6.94095 5.99865 -8.76526 9.77307 4.96327 -452 2 16.7516 7.41234 6.24421 7.68049 3.9133 2.85915 -453 2 16.2393 6.06165 5.75492 3.70751 -7.34759 -2.0072 -454 1 15.1339 7.14501 9.07066 -1.17949 -23.8082 27.0602 -455 2 15.8283 7.58235 9.55517 11.4438 5.0236 10.3868 -456 2 15.1116 7.57875 8.25013 -4.20744 20.1878 -38.3409 -457 1 6.25297 12.9267 12.7452 -4.72449 1.01458 -5.57239 -458 2 6.98991 12.3599 12.9819 6.62509 -1.61272 7.49964 -459 2 6.12032 13.5727 13.4468 2.47956 2.45399 3.39123 -460 1 12.1116 4.51066 13.1059 -15.4407 -10.6836 -10.9314 -461 2 12.4271 4.59486 14.0171 -10.4637 -2.65404 1.19035 -462 2 11.2547 4.00523 13.0473 26.1752 13.1928 8.83048 -463 1 11.3958 8.13336 7.91828 -4.43196 -2.05658 -14.2843 -464 2 11.9753 7.54394 7.4184 3.39578 1.92795 -0.521112 -465 2 11.8257 8.23937 8.76441 1.22007 0.905858 11.3028 -466 1 17.1296 10.8754 7.54699 -15.2323 -0.655909 3.97588 -467 2 17.811 10.2663 7.31344 17.8297 -18.4071 -0.448075 -468 2 16.9935 11.379 6.74844 -4.7697 12.6356 -6.62113 -469 1 5.29547 18.1363 10.9421 18.5805 -0.935137 -5.10578 -470 2 4.88577 17.8485 11.7431 -9.76906 -7.6723 14.1577 -471 2 4.62403 18.0611 10.2783 -13.9129 1.88822 -17.2145 -472 1 7.59234 17.5076 1.75687 4.86523 1.07577 -14.9702 -473 2 8.00304 16.7666 1.28453 -8.52174 0.253094 2.89961 -474 2 7.35564 18.1425 1.05706 3.89665 -2.44167 8.83688 -475 1 1.92302 12.8778 13.5789 2.91886 3.94981 -7.24471 -476 2 1.45818 12.4106 14.2651 -5.47786 -10.2367 6.99308 -477 2 2.33812 13.6191 14.0211 -0.459782 9.91978 4.14062 -478 1 9.50973 6.75636 14.7983 0.267759 -13.8501 3.13598 -479 2 9.76861 5.87974 15.1842 -3.78976 20.025 -16.8859 -480 2 9.67323 6.78366 13.8359 6.07296 -1.5477 12.5306 -481 1 15.3007 4.25662 10.7816 1.6835 6.93604 -0.852744 -482 2 16.2201 3.94716 10.8841 -13.758 11.9338 1.00514 -483 2 15.2044 5.07319 11.3041 5.68258 -12.2185 -1.66994 -484 1 11.2682 6.20917 0.148653 5.11845 2.03204 -0.614283 -485 2 11.4613 5.3156 18.5351 10.8417 -13.6045 -1.35957 -486 2 10.3344 6.26425 -0.02153 -13.2524 10.0913 1.35666 -487 1 -0.0515508 11.3921 15.0043 28.8186 -12.3739 35.7691 -488 2 18.1888 11.7008 14.2289 -27.1505 12.4881 -39.8426 -489 2 -0.144753 12.1488 15.5889 -3.39882 3.34168 7.51926 -490 1 7.01363 9.26741 7.30523 1.11866 9.50703 -8.15996 -491 2 6.64493 8.42979 7.58084 -4.10674 -7.85165 7.60391 -492 2 7.94964 9.11568 7.16987 5.72986 -2.82238 2.51511 -493 1 18.3266 15.3189 12.3109 1.98396 7.8422 -1.62162 -494 2 0.557814 15.686 12.1521 7.34904 -2.57966 -0.481227 -495 2 17.7488 15.821 11.7275 -2.3238 -0.409324 -3.46342 -496 1 16.5074 4.41847 5.29023 -12.2776 2.5176 -39.1335 -497 2 16.8214 4.00292 6.06235 10.453 -12.003 36.2431 -498 2 17.1989 4.29433 4.62557 3.70164 8.40848 3.22117 -499 1 17.7062 3.18115 10.7633 -10.0415 -0.498888 0.968384 -500 2 18.5829 3.451 11.0307 13.8857 -2.29821 0.377097 -501 2 17.7544 2.33603 10.3089 5.51555 -4.87272 -1.50428 -502 1 12.31 -0.0249004 10.0958 7.06597 -29.3992 -7.90418 -503 2 11.4091 0.228435 10.2265 -21.0592 11.9526 6.39906 -504 2 12.8361 0.735194 10.2786 15.1995 22.0824 4.66414 -505 1 10.3672 9.76964 12.4555 1.27225 -3.68083 -7.54967 -506 2 11.1341 9.82258 13.035 0.839453 -0.704743 2.83749 -507 2 10.2702 8.82174 12.2801 -0.554943 5.543 3.04928 -508 1 0.65465 2.77798 7.04528 -2.13863 -3.2199 7.00126 -509 2 0.891211 3.42266 7.72053 -0.0150652 2.55779 -0.825415 -510 2 0.990123 1.95336 7.40694 -1.54003 -2.33595 0.508806 -511 1 0.295674 15.3348 6.84982 -3.22172 27.5014 26.3495 -512 2 0.521244 15.1551 7.76985 -0.748412 3.60522 3.47657 -513 2 0.484365 14.5358 6.4159 11.6769 -37.1534 -21.5269 -514 1 17.0573 6.99129 15.1128 -10.0859 0.519269 -2.81001 -515 2 17.7626 7.64158 14.9811 2.36054 -7.88383 3.70046 -516 2 17.4128 6.20418 15.5441 6.5971 2.49163 -1.29874 -517 1 9.10445 12.4501 8.04005 25.0355 12.8023 20.768 -518 2 9.46092 11.7782 7.45434 -7.91968 -3.65307 -8.74082 -519 2 8.16829 12.5393 7.95206 -19.3694 -6.70788 -7.44718 -520 1 1.22811 1.76814 2.9182 -6.11732 -10.0295 -0.237983 -521 2 0.712195 2.08081 2.16479 2.12402 6.69579 0.750032 -522 2 1.58605 2.52034 3.3947 3.99278 5.86411 -0.360805 -523 1 4.10894 15.0956 9.93451 6.69744 -1.75099 -1.18621 -524 2 3.96901 15.3261 9.00671 4.91376 -1.44666 0.188494 -525 2 5.04659 14.871 10.0423 -6.23862 1.0691 -5.37016 -526 1 7.35274 2.18983 14.6875 -7.358 8.13743 -4.11606 -527 2 7.08638 1.65776 13.9297 0.32385 -1.91134 2.32143 -528 2 7.57979 3.04743 14.3014 5.83731 -4.25907 3.58957 -529 1 18.4915 14.5922 2.16266 -14.7631 20.4811 3.31696 -530 2 0.685462 15.0501 2.31645 0.801171 -7.89169 -2.84158 -531 2 17.8141 15.3012 2.20781 8.07106 -12.7893 -1.48401 -532 1 9.99475 2.73128 12.8993 -0.14498 6.34622 4.34107 -533 2 9.94968 2.10764 12.1674 -2.02697 0.25981 -1.25528 -534 2 9.23805 3.32791 12.8055 1.37719 -5.85529 0.104676 -535 1 2.96937 8.88969 13.0348 8.45161 15.4602 -1.6792 -536 2 3.19044 9.8379 12.866 -0.537566 -21.2484 3.2835 -537 2 3.7799 8.47356 13.3849 -14.589 3.50084 -4.12479 -538 1 3.21 8.56161 3.75492 -0.42537 -8.47878 -37.7314 -539 2 3.66747 9.30861 3.32521 -2.76458 -7.90594 7.43156 -540 2 3.22415 8.6869 4.6856 3.07128 8.62247 25.8231 -541 1 5.62342 7.20688 8.60781 8.60088 8.53717 -11.0276 -542 2 5.53536 6.26871 8.41561 -2.891 -1.4677 7.62716 -543 2 4.92494 7.48858 9.21156 2.86443 -6.54236 0.635755 -544 1 14.9008 1.47426 1.89198 -2.54888 27.9205 4.61998 -545 2 14.5535 2.29499 2.28075 -2.57285 -15.9361 9.92214 -546 2 15.4844 1.8547 1.23467 3.18874 -15.0862 -12.382 -547 1 8.48736 15.1158 0.783841 -1.15568 2.93173 4.22404 -548 2 9.1238 15.1934 1.5071 4.62293 -5.62872 -5.40551 -549 2 7.79285 14.5509 1.14844 -2.73481 2.50701 -2.31707 -550 1 15.539 1.37952 7.19688 19.4515 3.6409 9.83231 -551 2 14.9389 0.78101 6.7773 -13.8468 -10.3512 -10.8641 -552 2 15.0003 2.07296 7.57775 -6.55979 11.3773 -1.03994 -553 1 5.01034 12.9912 18.4705 -11.9235 -4.12885 0.570622 -554 2 5.4698 12.9987 0.669061 0.312037 0.832023 7.43214 -555 2 5.59011 13.4721 17.8825 4.88062 -0.262691 -5.03625 -556 1 15.3764 8.57785 18.0866 -6.62354 -11.676 10.0569 -557 2 15.6805 9.14973 17.3909 9.52323 10.3388 -11.2321 -558 2 15.2475 9.1488 0.206008 -1.03261 3.33477 1.75561 -559 1 12.066 3.08414 18.3349 -10.3405 10.2428 -1.58162 -560 2 12.3601 2.47993 0.38654 4.70786 -1.39849 -7.75748 -561 2 12.2507 2.72995 17.4495 4.61736 -8.1861 15.8047 -562 1 13.1968 12.6883 5.15757 -0.336282 2.96846 2.60586 -563 2 13.7743 11.9999 4.79412 -5.71366 -0.326721 6.52296 -564 2 13.1697 12.5812 6.12031 6.45904 1.498 -4.43193 -565 1 6.0986 7.21596 0.138974 -12.0498 11.3036 0.237585 -566 2 5.91833 8.16028 -0.0709607 9.65884 -21.2748 10.0237 -567 2 5.34258 6.95155 0.690129 5.85049 -3.44248 -7.26534 -568 1 17.7044 15.8891 14.9714 -7.43083 8.66678 -26.2685 -569 2 16.7907 16.1885 14.8618 6.06094 -1.91119 12.6189 -570 2 17.95 15.7638 14.036 5.46338 -3.82161 12.7361 -571 1 13.1509 0.939295 16.6327 -8.19033 8.72571 -1.54201 -572 2 14.0859 0.833936 16.7968 10.9207 -0.957234 5.29932 -573 2 12.8431 0.0418051 16.5014 -5.83506 -5.32332 -1.35137 -574 1 10.9522 14.5534 7.35938 -9.11436 -19.3925 22.6665 -575 2 10.1531 14.2304 7.85485 20.6615 9.00594 -18.4516 -576 2 11.6365 13.8859 7.56325 -5.91964 10.2955 -7.71128 -577 1 17.5919 8.49388 2.10024 -0.0322199 -9.95032 2.76416 -578 2 16.7206 8.43914 2.53345 10.0393 -1.69965 -6.58888 -579 2 17.6862 7.68098 1.5623 -5.40062 15.1321 4.16518 -580 1 12.403 7.83298 1.98454 10.1699 2.43182 8.97059 -581 2 11.823 8.58837 2.10452 -0.914469 2.41145 -5.63632 -582 2 12.0432 7.27751 1.28772 -5.41827 0.0907324 -1.12401 -583 1 12.0169 14.6214 10.4613 22.6496 -4.80377 11.9203 -584 2 12.2953 14.2566 9.62296 -0.627137 -3.48742 -6.53871 -585 2 11.0904 14.7922 10.4232 -26.4922 1.86569 -7.97999 -586 1 6.79945 6.92747 15.5042 -19.94 -13.6896 0.562857 -587 2 7.71181 6.85747 15.2524 19.187 5.43316 -2.40109 -588 2 6.75196 7.52139 16.2502 2.78602 4.81827 4.32857 -589 1 8.02489 4.54706 13.3799 -9.17747 17.7449 0.879178 -590 2 7.13549 4.71954 13.0119 14.9133 -0.721221 -4.30494 -591 2 8.45659 5.41872 13.4818 -10.582 -17.269 -1.29002 -592 1 13.3893 12.1928 14.3557 -6.07818 9.44403 7.21842 -593 2 12.9754 11.3343 14.2402 3.84433 -8.34325 -3.30791 -594 2 13.789 12.4346 13.5154 0.839467 -1.50598 -4.68274 -595 1 14.6037 9.51924 7.26293 11.3016 8.32374 8.02904 -596 2 15.4883 9.92697 7.3747 -13.533 -2.89904 3.77438 -597 2 14.03 9.85877 7.96896 6.22863 -2.20078 -8.30261 -598 1 12.724 16.8794 3.24165 4.36843 -29.0517 -11.6906 -599 2 12.9143 17.2056 4.10583 4.58985 8.72699 22.0136 -600 2 12.2764 17.5776 2.79705 -13.1015 20.2627 -13.4405 -601 1 1.027 7.08618 17.3856 17.8688 -9.35062 9.83545 -602 2 0.150845 7.20834 17.7372 -11.0357 -5.72224 6.2597 -603 2 1.04228 7.56687 16.5674 -0.430665 10.2682 -15.3686 -604 1 12.9047 4.96423 15.6783 -31.9319 9.90183 -0.420667 -605 2 13.6101 4.38571 15.8945 27.3027 -16.194 0.870052 -606 2 13.2534 5.85423 15.7473 6.89498 8.57473 1.28829 -607 1 2.36359 3.37095 5.13131 13.5367 -21.0772 -51.8355 -608 2 1.78827 3.18983 5.83511 -26.0337 -9.2034 36.1161 -609 2 2.76982 4.19309 5.31063 16.9607 33.0577 11.3338 -610 1 8.25673 11.0457 13.6214 -29.0742 18.4766 -42.051 -611 2 8.3505 10.9269 14.5387 12.3752 -9.07103 37.7912 -612 2 9.04494 10.7715 13.1556 11.3248 -9.59576 5.23465 -613 1 12.933 1.51857 13.2538 -7.42773 -10.5209 16.1392 -614 2 13.555 1.47666 12.536 9.8649 3.44918 -12.9241 -615 2 12.6435 2.43109 13.2999 -2.22529 4.34734 -4.74481 -616 1 6.5593 13.6321 2.14465 -6.91915 6.53865 -12.6846 -617 2 5.89828 13.9136 2.78341 -2.94652 3.12599 2.20918 -618 2 7.14809 13.061 2.63026 6.2374 -5.23981 3.14213 -619 1 15.8933 6.50668 12.6624 16.2584 4.45316 -6.00807 -620 2 16.3963 7.03445 12.007 -8.38894 -8.88658 12.5353 -621 2 16.4415 6.50555 13.4748 -12.028 3.27562 -10.9527 -622 1 16.7983 0.717045 9.56947 3.68169 11.9749 4.12436 -623 2 16.6133 18.4601 9.81273 2.15246 -18.3954 6.85595 -624 2 16.3759 0.833391 8.71872 -3.66349 3.7587 -11.8412 -625 1 6.14397 11.6556 8.30338 8.0817 56.4015 -2.32443 -626 2 5.40727 11.3941 8.82366 -25.1595 -10.6153 12.4164 -627 2 6.54205 10.8782 7.99323 17.2725 -41.4748 -11.5815 -628 1 2.81032 8.69956 0.356218 24.742 -6.25 8.21391 -629 2 2.27105 8.19016 18.4013 -14.5977 -1.17978 -6.66412 -630 2 2.29881 9.42159 0.72289 -11.078 1.63045 0.198871 -631 1 10.1064 10.4292 6.59515 -4.60438 -3.93729 0.830471 -632 2 10.5227 9.70923 7.07758 4.69601 -3.0134 2.20114 -633 2 10.434 10.3774 5.69507 4.10481 0.747976 -4.90006 -634 1 6.80466 15.7541 6.67201 6.06476 3.31695 -2.74514 -635 2 7.12474 16.199 7.46137 -2.48244 -3.95514 6.52968 -636 2 7.21004 16.2686 5.96286 -5.79252 -2.21211 -4.39766 -637 1 6.45958 12.986 5.74076 6.97467 7.4921 0.177054 -638 2 6.67553 13.8767 6.05203 0.11849 -2.56514 -0.0944634 -639 2 6.15828 12.5051 6.51647 -3.32664 -1.56183 1.61673 -640 1 16.774 12.5213 9.71798 -12.6143 2.89661 19.2402 -641 2 17.0082 11.8947 9.03708 5.67192 -3.35034 -8.73073 -642 2 17.3962 13.2453 9.69208 4.02202 2.48097 -6.52464 -643 1 6.17384 2.92225 2.79448 3.9775 16.0199 -22.3947 -644 2 6.54801 3.78326 2.49667 -7.94175 -14.5768 11.9424 -645 2 5.69703 2.59738 2.01124 2.48224 -4.95439 10.1002 -646 1 10.7977 3.13994 3.23713 3.9771 -4.26255 2.57443 -647 2 10.0782 3.73781 3.45741 -0.0760182 2.97522 -1.01161 -648 2 10.5069 2.61778 2.47973 -3.48459 4.35709 1.40724 -ITEM: TIMESTEP -70 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.80152 6.81783 17.9876 -13.1435 8.65537 6.0931 -2 2 7.93927 7.0215 18.3978 9.39494 -6.73756 -6.11522 -3 2 8.64173 6.15327 17.319 -1.79792 -4.8767 -3.2487 -4 1 0.159104 8.33212 6.75565 -1.75886 1.86255 -0.283403 -5 2 0.400553 7.98898 5.87058 -1.56937 3.6046 13.6337 -6 2 0.532733 7.75931 7.44677 0.588181 -1.3305 -10.9259 -7 1 8.56014 0.2064 6.86713 15.1827 -2.1442 1.30375 -8 2 9.48839 0.201881 6.58247 -8.47619 -0.963055 4.35965 -9 2 8.1657 0.891093 6.32874 -5.18544 5.82437 -2.7504 -10 1 6.48158 1.74839 11.7303 -5.73112 -6.99234 -4.49671 -11 2 5.77966 2.25139 12.1582 1.03612 1.63173 -0.79005 -12 2 6.04661 0.9684 11.3341 5.10627 10.6526 7.94811 -13 1 6.96595 5.58057 2.38836 1.68885 13.6464 8.05547 -14 2 6.50498 5.94206 3.17078 2.94101 -7.34901 -12.8293 -15 2 6.93975 6.29059 1.72807 -1.07971 -9.74986 0.444847 -16 1 16.2371 10.2379 16.1019 -30.9876 -7.62323 7.88585 -17 2 17.0175 10.5802 15.7054 20.7335 11.057 -7.58035 -18 2 15.6477 10.9912 16.2983 15.508 -10.4523 -2.02188 -19 1 10.7008 14.9379 2.28795 4.31472 -8.51672 3.50984 -20 2 10.6635 14.2367 2.95607 -1.08681 7.31624 0.965 -21 2 11.2207 15.6296 2.69467 3.48557 9.19098 3.66151 -22 1 17.1795 8.23023 10.7992 8.53416 -1.59534 -8.67541 -23 2 16.5643 8.83199 11.2261 -1.39923 4.26423 7.56567 -24 2 17.9421 8.77596 10.5426 -4.34729 -3.75626 -0.741474 -25 1 14.6688 15.978 16.4285 2.33326 -11.9168 -2.20454 -26 2 13.7825 16.2968 16.2522 -6.84331 1.16869 1.85073 -27 2 14.5784 15.3806 17.1932 6.40998 12.5602 -6.81985 -28 1 12.1084 13.347 0.550082 18.7888 -12.4001 5.31554 -29 2 11.808 13.4241 18.2861 -6.00468 7.05887 -5.4437 -30 2 11.724 14.0175 1.12482 -9.88619 2.03399 -6.75529 -31 1 9.30709 5.48775 3.90966 3.41698 -5.29876 17.2174 -32 2 8.77877 5.25688 4.68667 5.61339 2.83044 3.00189 -33 2 8.64592 5.55872 3.2299 -8.10772 2.16644 -16.0449 -34 1 1.64595 4.02425 11.592 -10.9656 22.1289 -13.9701 -35 2 1.60629 4.97108 11.8395 -0.824037 -11.4025 -3.90562 -36 2 2.20491 3.59841 12.2231 10.5337 -11.1868 16.6964 -37 1 2.06621 6.87149 8.22737 1.24172 3.77126 1.52806 -38 2 2.50304 7.30143 8.97949 -2.75541 -3.2118 -2.64013 -39 2 1.97282 5.93715 8.45613 -0.171499 4.52155 4.26063 -40 1 5.3374 4.4954 7.902 -9.99384 -2.48662 -4.40208 -41 2 5.3873 3.53885 7.92862 5.32096 -10.0353 0.506932 -42 2 4.78906 4.68538 7.13029 -0.632429 8.18831 0.496784 -43 1 3.33945 2.92164 17.4119 -9.04777 -8.0172 12.2496 -44 2 4.01569 3.37904 16.9228 10.8208 5.2633 -7.4392 -45 2 2.90871 3.59334 17.9575 0.609467 0.189965 -2.29637 -46 1 7.45919 5.40741 6.16401 6.01334 0.147035 -1.33637 -47 2 7.84933 5.9815 6.83711 3.51741 -4.84398 -5.3698 -48 2 7.00259 4.70355 6.63733 -2.11297 5.93299 1.70682 -49 1 9.81228 7.01862 12.0561 -1.06857 0.870105 -3.24483 -50 2 10.2542 6.3375 11.5392 -2.78202 1.90065 -0.0845581 -51 2 9.1292 7.39963 11.4807 2.35361 -4.5728 1.86322 -52 1 13.9947 3.68643 8.08173 -5.65395 18.5094 -17.1015 -53 2 13.7843 4.54079 7.64233 1.50666 -18.9 8.64197 -54 2 14.1479 3.8993 9.00085 4.5059 2.7709 6.99075 -55 1 4.5073 17.1442 3.93435 4.48768 -12.0008 8.39889 -56 2 5.39081 17.5321 3.92633 -2.26089 2.72179 -5.35255 -57 2 4.01543 17.3459 3.13072 5.98217 13.0117 -0.399635 -58 1 16.4079 16.585 10.4121 -12.3499 -1.91652 -12.9082 -59 2 15.5551 16.5364 10.8674 2.44262 -0.34105 -1.56006 -60 2 16.2254 16.2298 9.51738 1.66683 0.349555 15.5208 -61 1 1.97926 4.78245 0.194184 -7.72676 6.8376 3.32149 -62 2 2.28164 5.2243 0.992573 8.53964 -6.59001 3.21257 -63 2 1.76914 5.52567 18.27 -2.63275 2.53007 -9.16672 -64 1 11.4134 13.2491 16.3873 0.68902 5.27402 2.7566 -65 2 10.9787 12.3908 16.4988 0.445492 6.36744 -3.52589 -66 2 11.9797 13.161 15.6117 0.593117 -3.37138 0.847423 -67 1 10.1151 10.9818 16.8138 12.4788 0.931853 3.10073 -68 2 10.558 10.1255 16.7937 -4.12284 -0.882862 -0.541555 -69 2 9.18349 10.8105 16.7424 -13.6774 -3.43657 -1.9902 -70 1 11.7994 17.4667 13.4795 12.7765 -4.5476 -2.07039 -71 2 12.3346 16.8373 12.9682 -4.67996 5.77396 2.18605 -72 2 12.2169 18.3179 13.2967 -7.11407 5.85224 3.16387 -73 1 6.41771 9.40938 12.2612 -1.11473 -8.0868 -15.4525 -74 2 7.03744 9.07449 11.5759 -13.2083 9.2101 17.4474 -75 2 6.9295 9.8935 12.9066 11.874 3.71682 2.38348 -76 1 16.2958 12.8923 2.71536 -7.68956 9.05075 5.11912 -77 2 17.1057 13.405 2.60095 0.726983 -7.0699 -1.53932 -78 2 15.5966 13.5689 2.77432 5.93986 -8.84533 -0.161974 -79 1 0.748159 12.7086 5.88144 -10.9756 -4.32923 1.80334 -80 2 1.126 12.5118 5.01571 -4.75041 4.90571 -2.30818 -81 2 18.4243 12.6438 5.75836 11.281 1.67442 1.09101 -82 1 5.27578 16.4085 18.412 4.21131 -11.5608 4.53747 -83 2 5.56823 15.5611 18.0525 -2.79743 5.31701 -3.02359 -84 2 5.61546 16.4141 0.666595 -0.372752 7.00853 0.303479 -85 1 0.645783 7.7249 4.17395 -22.5174 -18.1833 12.2453 -86 2 0.0406635 8.03244 3.50183 -6.8254 3.26088 -7.40309 -87 2 1.47404 8.07846 3.91568 30.354 9.58108 -9.75695 -88 1 3.15689 8.99663 6.46784 -29.6014 22.5811 -11.1032 -89 2 3.73467 8.6187 7.10087 15.4493 -13.4368 20.8179 -90 2 2.24881 8.95158 6.82736 13.2955 -4.68481 -5.71698 -91 1 7.31562 10.4015 16.2316 3.59442 1.76188 5.73087 -92 2 6.55849 10.6763 15.7162 -1.33577 1.2968 -0.922241 -93 2 7.0153 10.388 17.1537 0.717273 -3.98644 -9.35278 -94 1 11.0545 0.930228 4.99952 5.57476 -3.06583 5.10436 -95 2 11.2493 1.80197 4.63341 -8.70362 -0.159614 -5.22362 -96 2 10.8601 0.352804 4.24475 -0.891787 5.80331 3.4075 -97 1 4.31226 2.88036 13.174 -5.147 13.5187 -3.07305 -98 2 4.38813 3.36721 14.0053 4.89736 -4.04185 -0.502489 -99 2 4.16611 1.96327 13.4122 -1.31506 -9.67947 3.52696 -100 1 8.44169 10.2311 1.79631 7.56357 -11.9838 -1.9735 -101 2 8.31668 10.8926 2.47474 -4.45102 7.488 6.50539 -102 2 8.68604 9.43265 2.286 -2.4935 0.872154 -3.30188 -103 1 10.3613 1.71229 15.5051 2.98347 -4.15867 -5.41234 -104 2 11.2858 1.47948 15.6006 4.17674 0.252173 3.54686 -105 2 10.224 1.77346 14.5485 -4.83776 4.02156 4.39256 -106 1 2.62824 12.9587 7.89058 0.896502 -11.3927 -2.22701 -107 2 3.24219 13.4607 7.34422 -0.123332 4.88452 0.659902 -108 2 1.95928 12.6032 7.2874 1.64097 5.4786 -0.796639 -109 1 3.80872 11.636 4.95037 -11.7682 3.18495 22.2339 -110 2 3.64598 10.9456 5.61445 0.836076 6.10931 -6.44063 -111 2 2.95096 11.8687 4.56439 8.15456 -6.07271 -3.548 -112 1 6.68955 14.4669 16.969 -3.81156 3.78561 -6.36768 -113 2 7.31157 15.1356 17.2607 6.01474 -1.04117 -0.64393 -114 2 6.3928 14.7335 16.0851 0.840242 -1.58899 4.15547 -115 1 14.2051 14.5083 3.2908 -7.03725 6.3674 -0.58292 -116 2 13.7783 15.3639 3.15563 1.95336 -1.87129 -0.261548 -117 2 13.7683 14.1355 4.06228 2.52608 -4.66484 0.961916 -118 1 8.56009 18.0702 16.0712 3.20396 -8.67406 4.91505 -119 2 9.14753 17.3445 16.2475 -6.34669 -24.466 3.58587 -120 2 9.1857 0.126611 16.1642 1.87484 33.3672 -8.78222 -121 1 4.70115 1.72624 4.89274 27.4793 -6.96303 -5.48355 -122 2 3.95894 2.26041 5.13304 -17.2548 11.1403 -0.356707 -123 2 5.27782 2.26423 4.3214 -9.62564 -3.87491 4.20048 -124 1 15.0192 12.5587 16.5123 21.7041 14.8698 31.7439 -125 2 14.5985 12.983 17.2917 0.468388 -8.58398 -21.4185 -126 2 14.4797 12.5149 15.7347 -25.1252 4.80555 -9.98379 -127 1 15.7034 18.4851 16.8595 11.2428 14.4774 5.40242 -128 2 16.3726 18.3616 17.5507 -1.30019 6.81093 -3.04699 -129 2 15.2229 17.666 16.8625 -3.30988 -17.6635 -4.60623 -130 1 1.33118 1.27529 16.6047 -9.4861 0.393225 2.74141 -131 2 2.17004 1.71925 16.7831 -4.45817 3.09534 0.768406 -132 2 0.687638 1.66877 17.2201 8.28198 -2.79213 -3.95818 -133 1 18.1871 4.40384 15.9188 -4.2246 -5.6904 -13.4727 -134 2 18.0103 3.84369 15.1415 2.73285 7.2293 11.0268 -135 2 0.486098 4.58175 15.924 0.765927 0.250404 0.0527718 -136 1 12.1931 17.0307 16.1573 -7.03075 -8.39993 15.6705 -137 2 11.4402 16.4961 16.4862 10.3932 12.5123 -4.95214 -138 2 12.1197 17.0939 15.2076 -10.1529 0.179256 -12.7611 -139 1 16.106 2.59107 18.2096 -1.1157 3.6739 1.58184 -140 2 15.8464 3.51014 18.3379 -6.23469 -2.00336 3.76026 -141 2 15.8431 2.36085 17.3192 0.233798 0.882779 -7.24243 -142 1 6.71273 13.8002 10.1277 -4.97427 -8.24119 9.58999 -143 2 6.56779 13.4217 11.0085 1.93353 6.26249 -2.22943 -144 2 6.54815 13.0587 9.53715 2.49444 0.869035 -6.59786 -145 1 10.1873 18.4315 2.70955 18.3562 4.9239 2.5593 -146 2 10.5434 0.318979 1.97838 -6.6136 -2.73616 6.22508 -147 2 9.38189 18.0459 2.39836 -17.7025 -5.54205 -6.95436 -148 1 3.04496 17.7072 6.14474 -26.0897 -13.5421 -17.7616 -149 2 2.15406 17.5302 5.73662 26.1077 6.8467 16.2169 -150 2 3.64192 17.5514 5.40101 1.03601 7.77362 4.67988 -151 1 12.6273 16.8318 7.93854 -11.3452 0.662957 5.12661 -152 2 11.8845 16.2201 7.89678 1.40738 -6.80959 -10.3945 -153 2 12.3926 17.3902 8.68441 7.00662 7.84172 2.34647 -154 1 14.8855 15.2416 8.18261 -13.4645 13.8861 12.0711 -155 2 14.0556 15.7424 8.32689 13.5062 -6.9847 -4.51651 -156 2 15.2561 15.6092 7.37576 4.4997 -5.95581 -2.20609 -157 1 17.7963 18.2323 0.313468 22.8316 -1.73762 -16.8861 -158 2 18.5551 17.7341 -0.0636659 -20.2187 -0.580139 11.9305 -159 2 18.2144 0.43747 0.484185 -10.4644 5.54896 5.21224 -160 1 0.772309 10.5133 1.37975 -10.1333 -30.1062 6.79594 -161 2 0.0813059 9.81759 1.5081 15.2254 18.695 2.54909 -162 2 0.385285 11.1613 0.797203 -0.976125 9.32481 -5.57513 -163 1 1.78018 12.2676 3.33949 2.15539 9.4235 -7.57379 -164 2 1.54035 11.6193 2.6706 -4.1225 -6.27654 2.3776 -165 2 2.05243 13.0385 2.81809 -2.70385 -1.96831 6.56166 -166 1 0.659925 17.2426 4.96586 -18.1386 9.04401 18.0738 -167 2 0.178596 18.0473 5.21064 6.21229 2.02654 -16.1731 -168 2 0.324647 16.6226 5.62628 12.0605 -8.44774 -8.6881 -169 1 1.10032 0.835558 9.36207 -6.74911 6.08386 15.0138 -170 2 1.34007 0.666464 10.2949 -2.02307 -2.81345 -10.1719 -171 2 0.1714 0.592543 9.31025 -1.22709 -3.40717 -2.54195 -172 1 16.7505 2.35163 13.3289 8.60057 15.8485 -12.5846 -173 2 16.88 2.58008 12.3859 -1.48994 0.98841 16.7513 -174 2 16.5792 1.4154 13.3346 -5.94985 -15.1034 2.43107 -175 1 2.68711 15.9094 12.0537 -2.04437 -0.129745 31.1177 -176 2 3.02052 15.4906 12.8711 -6.40464 9.26827 -14.3072 -177 2 3.17282 15.5129 11.3342 0.535683 -2.02659 -8.3952 -178 1 16.4208 15.6182 6.1352 -21.1289 -3.6799 -9.5135 -179 2 17.2955 15.5836 6.51556 8.3115 3.57969 -3.1518 -180 2 16.3537 16.3493 5.49765 5.76519 -7.13598 7.22522 -181 1 5.79664 5.13529 11.8088 -4.38676 10.3557 2.90642 -182 2 5.60006 6.00552 12.2032 -0.739769 -8.67447 -3.0914 -183 2 5.02307 4.59055 11.9941 4.66701 -2.35447 -0.0408817 -184 1 15.1607 4.87263 0.806669 16.5091 -1.57376 7.82361 -185 2 14.8955 4.71033 1.72542 2.63671 -2.24198 -6.9535 -186 2 14.4069 5.23734 0.370441 -15.2288 7.71764 -6.62645 -187 1 16.3977 16.3968 1.96949 3.68196 12.8197 -24.7966 -188 2 15.8359 16.7471 2.65913 3.23547 3.93446 11.4731 -189 2 16.7724 17.1777 1.4991 -6.44753 -16.1278 10.1249 -190 1 0.213933 4.82135 3.88253 -26.808 7.93653 -12.3623 -191 2 0.234051 5.77519 3.99531 2.75938 5.29795 -1.25016 -192 2 0.961943 4.50047 4.34745 23.7428 -13.1307 13.4767 -193 1 2.96019 15.0595 15.1256 -5.74802 5.98414 7.79678 -194 2 2.74143 14.6748 15.982 5.94976 -7.2483 0.528018 -195 2 2.64636 15.9627 15.2549 -2.4967 2.40481 -11.2251 -196 1 1.11613 14.6445 9.47707 24.3082 -3.71628 -27.1602 -197 2 1.83443 14.0608 9.11052 -24.4018 17.7336 11.9542 -198 2 0.662892 14.1245 10.1216 -3.75634 -10.5151 15.6601 -199 1 13.5123 16.5361 11.5209 14.3415 8.92342 18.194 -200 2 13.0624 17.3115 11.1648 -0.833334 -0.722864 -7.66511 -201 2 12.9752 15.7809 11.2867 -3.03575 -6.70349 -11.2125 -202 1 4.68996 1.46706 0.718872 11.9134 2.33738 12.4928 -203 2 4.09477 2.04355 0.241198 -5.36661 3.4607 -5.79099 -204 2 4.1604 0.969338 1.36347 2.85434 0.638429 -14.0321 -205 1 1.49954 18.563 11.8891 -5.50653 18.8512 6.56283 -206 2 1.44134 0.571379 12.6129 -0.0136494 -9.64138 -5.67935 -207 2 2.21117 17.97 12.1221 3.30859 -8.66659 1.78907 -208 1 11.4402 10.1273 4.0296 -14.1313 -2.26429 -1.73879 -209 2 11.5467 10.5306 3.16018 -4.20959 -0.177974 3.37558 -210 2 12.3237 10.0244 4.36159 16.2917 -0.468181 5.60308 -211 1 8.19952 12.1987 3.67367 7.5254 -0.929385 2.30686 -212 2 9.06593 12.5735 3.89529 -5.56433 -0.233543 6.4332 -213 2 7.60827 12.3201 4.43288 5.90715 0.804339 0.890554 -214 1 14.5695 4.00736 3.30806 -0.853883 -3.91237 -3.28064 -215 2 15.2428 4.12216 3.97778 4.83301 -0.192226 6.11595 -216 2 13.7947 4.43075 3.66998 -10.7695 5.18811 0.448659 -217 1 5.68852 1.65707 7.54168 28.123 23.6896 24.0894 -218 2 4.98915 1.23464 8.0079 -23.0977 -17.1785 12.6492 -219 2 5.54722 1.47278 6.63267 -9.12733 -3.0122 -32.3212 -220 1 17.8871 1.01837 4.84182 2.82015 7.71075 0.411156 -221 2 18.4334 1.54735 4.24341 -1.55475 -9.21419 -1.50179 -222 2 17.685 1.60385 5.57556 -2.0638 -1.04483 2.6292 -223 1 6.8166 9.34907 4.51783 5.09473 -9.82493 1.7662 -224 2 6.68916 9.48214 5.46541 0.845655 -0.0829088 -1.52267 -225 2 7.72677 9.02302 4.42297 -5.47106 2.64724 -1.23342 -226 1 2.52902 14.8001 2.0243 -5.93162 -1.84873 -28.2955 -227 2 3.33024 14.7833 2.53171 11.9325 -2.28831 13.4023 -228 2 2.81062 14.7362 1.08886 -6.14041 -0.158095 16.8135 -229 1 17.2862 12.9192 13.1313 -13.4327 18.0081 -1.69868 -230 2 16.3974 13.2513 13.3936 19.5241 -4.39437 -6.93828 -231 2 17.8009 13.724 12.9107 -8.95295 -13.2998 3.51907 -232 1 14.8818 10.557 1.42323 -17.5015 7.25829 9.68839 -233 2 15.2835 11.3752 1.77244 -3.15433 -10.3089 -2.91904 -234 2 13.933 10.5609 1.67153 21.0133 3.93252 -5.34474 -235 1 5.70173 6.62264 4.58284 3.01718 2.50499 1.71703 -236 2 5.75902 7.56019 4.39794 2.55817 9.91828 -0.0203224 -237 2 6.42399 6.43452 5.20085 -6.85011 -4.70646 -2.52597 -238 1 8.0341 8.36204 10.3892 10.4405 -6.77488 -14.8808 -239 2 8.6296 8.90948 9.85447 -2.74542 2.30932 7.48232 -240 2 7.64772 7.74454 9.75603 -3.95063 2.60786 3.00172 -241 1 13.4272 18.4528 5.67238 9.25795 -5.11499 9.49722 -242 2 12.7163 0.440246 5.56173 -10.019 1.98309 -6.96611 -243 2 13.1619 17.9514 6.45613 2.7128 -4.57063 -2.8 -244 1 -0.0270522 2.62208 0.316378 14.2494 -14.2567 4.73545 -245 2 17.7181 2.78355 18.7164 -19.3625 -8.86024 -5.69671 -246 2 0.361548 3.46719 0.160861 21.2807 17.6319 0.792983 -247 1 12.9304 10.9756 9.73287 -28.9199 -18.5822 3.85047 -248 2 11.9453 10.9259 9.78333 22.7984 8.3459 -7.73181 -249 2 13.1639 10.0723 9.99967 2.00349 4.19966 -2.07729 -250 1 0.632704 12.1509 11.1096 7.92792 10.2243 1.08862 -251 2 18.3238 12.1837 11.2671 1.30826 1.36738 8.17016 -252 2 1.12128 12.4175 11.9061 -11.5401 0.628467 -1.63311 -253 1 5.16172 7.34292 13.3779 5.89076 -0.786387 1.26512 -254 2 5.63913 8.13751 13.0818 -0.253704 -8.62988 -1.18816 -255 2 5.64992 7.00871 14.1461 -2.49218 7.71701 -3.25354 -256 1 1.18315 6.80996 11.9457 -21.1971 9.90527 -11.1777 -257 2 0.396163 7.2181 11.5121 19.4256 -12.5543 10.5539 -258 2 1.74685 7.55572 12.1675 3.51989 2.12142 1.71712 -259 1 15.5171 9.71047 12.3281 2.29457 -6.5479 -4.23973 -260 2 15.3017 10.6102 12.0519 -2.15799 -4.39765 10.01 -261 2 15.6816 9.70968 13.2745 -0.591496 3.33032 -0.321137 -262 1 16.5873 12.6729 5.56721 2.76163 -0.166181 -5.31991 -263 2 16.3773 13.5773 5.84608 0.225425 -0.965456 -7.72797 -264 2 16.4542 12.6253 4.60029 -0.729256 4.09093 10.083 -265 1 6.36605 9.79142 0.024922 -16.0501 18.8211 -0.426432 -266 2 5.53971 10.2677 0.213525 8.17613 -4.10964 1.60097 -267 2 6.98218 10.0336 0.714657 7.30358 2.91784 7.9977 -268 1 12.2857 6.09281 4.02237 -18.7873 -18.2554 10.8389 -269 2 12.2499 6.90248 3.51498 -0.180994 1.77121 -11.4426 -270 2 11.3769 5.71462 3.99073 18.6718 6.8659 -0.0124277 -271 1 0.371339 12.8581 0.116813 -11.2914 -0.881026 -5.3546 -272 2 18.6979 13.4634 0.798717 1.88955 0.580482 0.906428 -273 2 18.4407 13.0157 17.9982 0.051521 1.66817 1.81741 -274 1 3.57562 18.6672 8.63597 16.8652 -4.29809 -8.00937 -275 2 3.39672 18.3023 7.75382 0.438355 1.17547 6.33464 -276 2 2.72388 0.290377 8.97499 -6.05452 1.31479 -1.62581 -277 1 7.38199 17.3678 4.46374 -1.38292 15.3105 6.33947 -278 2 7.69148 18.255 4.75287 -6.89683 -17.7129 -9.79531 -279 2 7.51455 17.3077 3.50947 0.595015 4.11355 1.7546 -280 1 9.26329 17.1448 12.185 -8.64248 6.96454 5.63337 -281 2 9.31183 16.2501 11.845 1.80177 -5.78684 -3.53436 -282 2 9.93599 17.2354 12.8685 5.43729 -1.39148 -3.55242 -283 1 13.2821 13.1028 8.02698 11.8692 -15.3168 6.16039 -284 2 13.4688 12.3189 8.5813 -8.97739 12.1367 -7.14337 -285 2 14.105 13.618 8.04076 -8.38267 2.98351 0.0644509 -286 1 14.8025 2.98142 15.4294 17.4288 1.80056 -2.61073 -287 2 14.201 2.26032 15.2834 -13.2348 -7.60023 -2.35086 -288 2 15.3302 3.01554 14.6169 0.118996 0.402428 5.45631 -289 1 9.92493 15.6251 16.9821 6.00495 -5.53666 -0.13681 -290 2 10.4191 14.8506 16.6821 -3.27256 -3.64184 -5.012 -291 2 9.59076 15.3546 17.8439 -3.58917 5.2502 2.724 -292 1 11.2797 8.49868 16.6198 -1.73472 -6.52809 -3.79184 -293 2 10.75 7.88393 16.0952 -2.42874 5.03231 0.808132 -294 2 11.4092 8.05007 17.4587 2.82097 -1.86681 0.519814 -295 1 4.04678 18.2455 16.7988 -8.77416 25.1666 -6.65304 -296 2 4.65779 17.694 17.284 2.06605 -2.99109 10.2548 -297 2 3.96053 0.454509 17.276 5.60906 -19.8799 -5.16878 -298 1 2.27095 4.25175 8.91936 5.9784 -6.58712 9.82608 -299 2 3.2186 4.2524 8.72216 -4.79336 -1.38402 1.94738 -300 2 2.18112 3.96584 9.85003 1.09756 8.39619 -11.3917 -301 1 9.88624 10.3936 9.78011 6.22166 -2.86793 -13.7384 -302 2 9.62293 11.2772 9.51568 -5.75811 3.67729 -6.27375 -303 2 10.0642 10.4241 10.7104 0.548842 -0.969577 22.0405 -304 1 9.71663 0.937962 10.8586 -0.709221 -7.70358 -11.4846 -305 2 9.30987 0.134657 11.1937 5.18354 -4.14977 6.17978 -306 2 9.11908 1.1943 10.1452 4.37988 8.3302 1.85952 -307 1 9.18198 15.0956 10.1953 -4.26962 6.22766 7.58802 -308 2 8.89777 15.9846 9.95951 0.743088 2.4445 -7.53567 -309 2 8.34997 14.6032 10.2066 5.52748 -3.88041 -1.79992 -310 1 0.872205 9.70338 10.2435 26.5305 -15.7209 -40.6294 -311 2 0.885793 10.5746 10.6186 -2.04601 10.7115 5.01116 -312 2 1.5471 9.74995 9.50099 -28.1395 -6.59839 33.8889 -313 1 17.1072 4.85649 8.10795 10.9462 -15.5033 5.93553 -314 2 16.3968 5.45295 8.31142 -11.4282 10.1371 2.96807 -315 2 17.1775 4.27052 8.87929 1.82351 6.10377 -11.9311 -316 1 14.794 14.6968 0.0807509 -15.0506 -16.2211 -7.1198 -317 2 15.1293 15.3316 0.707575 7.57499 5.98458 11.2724 -318 2 13.942 14.3729 0.412504 5.92115 1.12787 4.02247 -319 1 3.8058 11.0463 9.54758 -4.72716 5.89465 -11.0149 -320 2 3.75265 11.4758 10.4012 1.08641 -1.46789 11.7249 -321 2 3.34125 11.6425 8.94232 1.4747 0.62014 0.836248 -322 1 11.3036 10.7395 1.51518 17.421 7.70001 -9.9965 -323 2 11.5572 11.5513 1.04939 0.916953 -2.49636 4.28379 -324 2 10.3663 10.6689 1.38091 -17.6315 -2.91035 -1.9437 -325 1 13.1498 7.19173 12.6392 -12.6781 -12.1868 5.62798 -326 2 14.0645 6.9093 12.7169 6.63809 2.55694 -2.55252 -327 2 12.6264 6.38473 12.8035 6.43409 8.48166 -2.8301 -328 1 9.6244 1.91603 0.948782 1.73007 4.87205 -17.2591 -329 2 8.78103 1.84907 0.47922 2.387 -4.26061 4.8929 -330 2 10.2561 2.20979 0.275304 -2.56753 1.91417 5.98087 -331 1 10.6541 13.4625 4.53479 -4.64228 5.78216 2.02785 -332 2 11.5543 13.1406 4.67483 -3.60366 -2.8444 3.58336 -333 2 10.4931 14.1115 5.23949 3.28752 -7.90473 -1.94244 -334 1 14.4847 1.66582 10.9548 -5.6847 9.24739 -2.41061 -335 2 15.2495 1.25185 10.5509 3.51804 0.734089 -1.48015 -336 2 14.6665 2.62215 10.9157 -2.44239 -9.64589 2.94827 -337 1 14.5153 12.0551 11.6598 -8.57838 4.331 1.02894 -338 2 15.2406 12.4341 11.1775 15.6624 8.75252 -5.54666 -339 2 13.8905 11.8145 10.9694 -5.00706 -1.53612 2.9308 -340 1 8.18805 5.09916 9.82303 -13.8101 6.02591 4.86356 -341 2 7.31243 5.14562 10.2589 14.5937 -0.354252 -5.27398 -342 2 8.2462 4.20505 9.47267 -0.0530366 -3.80538 1.315 -343 1 1.47125 16.9173 18.4665 17.3664 16.657 -21.1079 -344 2 1.9236 17.2269 17.6455 -9.65792 -6.20403 18.6505 -345 2 1.59593 15.9726 18.4726 0.464255 -9.97504 -1.82966 -346 1 1.48039 17.3287 15.3228 1.51401 14.0556 6.72393 -347 2 1.34693 18.2292 15.6575 8.56134 -5.76509 -0.66881 -348 2 0.596093 16.984 15.2507 -11.2139 -7.77617 -1.25224 -349 1 3.58273 5.77174 6.05172 -7.98503 -18.1926 7.56457 -350 2 3.04578 6.35459 6.60151 3.24577 3.33226 -0.333817 -351 2 4.18271 6.30655 5.53303 2.15541 4.89174 -3.71227 -352 1 12.4965 9.48476 14.2165 -0.670713 16.0192 -6.73881 -353 2 12.9556 8.76438 13.7775 2.07937 -6.9932 3.10842 -354 2 12.3436 9.22115 15.1264 1.05397 -7.72063 3.19376 -355 1 4.0654 15.2599 7.01126 14.536 -9.99762 3.77636 -356 2 3.57418 16.0458 6.77165 -4.77502 7.81332 -2.1228 -357 2 5.00035 15.4681 6.83264 -6.89866 -1.23873 3.67355 -358 1 0.723833 8.69198 15.0851 1.39297 0.947643 -5.33928 -359 2 0.438801 9.60781 15.1421 -2.06214 4.43911 1.45744 -360 2 1.38458 8.70272 14.3802 0.858615 -3.42768 2.38717 -361 1 12.8756 8.29184 10.1606 18.5084 -5.85873 3.08502 -362 2 13.7209 7.89345 9.85142 -16.8549 4.13316 8.30657 -363 2 12.7515 7.97965 11.0724 6.23426 1.04322 -7.42686 -364 1 15.3229 7.8277 3.50947 17.5558 22.7432 -34.5468 -365 2 14.4697 7.71438 3.07339 -7.31906 -8.87793 15.8657 -366 2 15.4806 7.65388 4.43399 -18.8005 -15.0751 11.2523 -367 1 17.2596 6.73529 0.0260639 -2.34928 8.60384 0.474092 -368 2 16.7705 6.01921 0.434638 -6.55856 -4.92879 -0.567585 -369 2 16.5991 7.41683 18.4475 3.41319 -8.53114 -0.808778 -370 1 8.95463 6.95692 7.78734 -12.7059 -4.64784 9.91199 -371 2 9.87027 7.23168 7.81087 8.51327 4.71948 -0.0600656 -372 2 8.83651 6.35153 8.53608 0.68522 0.961995 -1.89804 -373 1 12.4059 0.607414 1.26231 3.62116 2.02707 -9.0712 -374 2 13.2571 1.01103 1.48145 3.02509 -6.80244 -1.55076 -375 2 12.4394 0.42011 0.312768 1.30302 -0.072107 7.45087 -376 1 5.61221 15.1181 14.5069 21.81 1.56396 -5.03583 -377 2 4.69671 15.2613 14.7447 -7.9418 2.21424 1.99916 -378 2 6.02853 15.9808 14.3125 -8.14435 -8.16553 0.0834836 -379 1 3.81616 6.42663 1.71897 -4.74342 3.6354 -4.79161 -380 2 3.34042 7.16969 1.31421 3.65203 2.80462 3.7212 -381 2 3.89499 6.64183 2.65143 -2.11765 2.44111 2.19083 -382 1 3.90516 11.4598 12.3793 9.45586 -8.94044 -12.3546 -383 2 4.79548 11.8227 12.4942 -7.15738 -0.735807 -0.876075 -384 2 3.31554 12.0782 12.7961 -9.4854 7.67777 7.65311 -385 1 5.30665 3.87758 15.8091 -6.5654 14.2288 -0.0449474 -386 2 5.99806 3.22942 15.6938 11.0923 -7.17561 -6.6845 -387 2 5.74209 4.7421 15.8325 -0.91092 -4.98763 -0.535492 -388 1 14.1952 10.2038 4.61463 -6.5923 1.74463 -22.8561 -389 2 14.2343 9.86507 5.49824 4.23866 -7.49318 19.2708 -390 2 14.5963 9.53108 4.04607 2.17028 4.66107 2.75401 -391 1 7.63145 17.3499 9.0679 -5.43123 5.71002 -0.0698024 -392 2 6.89643 17.6949 9.58041 -2.21022 -5.88459 7.45639 -393 2 7.83827 18.0718 8.46746 8.40651 -1.69566 -7.5742 -394 1 4.52514 14.4769 3.85867 5.05038 7.53463 5.39007 -395 2 4.64261 15.388 4.18066 -3.91408 -9.29834 -6.31781 -396 2 4.46355 13.9264 4.6465 1.7827 -2.93555 -2.6265 -397 1 14.2493 7.38723 15.8586 4.87219 -5.15553 -0.709446 -398 2 15.1473 7.29965 15.5014 -5.21416 1.68161 3.76194 -399 2 14.3665 7.7773 16.7353 0.544226 -0.39761 -4.2243 -400 1 3.0581 18.4144 1.95119 -22.1859 -8.41359 7.65322 -401 2 2.57832 17.7386 1.43356 3.30075 12.2585 2.4632 -402 2 2.38613 0.281938 2.45339 8.18993 -10.3808 -10.0068 -403 1 7.97435 1.63455 4.58282 23.9975 -9.20271 -17.826 -404 2 7.40194 1.94347 3.87976 -9.32013 4.13397 -1.27928 -405 2 8.80392 1.4125 4.10448 -12.4762 5.5818 15.8983 -406 1 2.4378 14.1623 17.6894 -3.94912 5.20331 -2.53114 -407 2 1.6661 13.615 17.8755 3.58117 1.8004 4.78536 -408 2 3.18519 13.6404 17.9779 13.28 -5.73443 1.82606 -409 1 0.901685 1.86492 13.8925 12.6905 0.691236 2.76957 -410 2 0.97461 1.67681 14.8348 2.02403 -0.73996 0.457614 -411 2 -0.0244921 1.99897 13.7259 -14.1961 2.08272 -4.4518 -412 1 4.37872 0.0904002 13.8777 13.1739 1.11326 -7.50903 -413 2 5.30332 18.4699 13.7308 -6.52685 1.52196 1.48666 -414 2 4.22979 18.5754 14.8098 -5.10379 -2.3914 9.04502 -415 1 7.27651 0.845893 18.3957 -16.6762 17.2151 26.568 -416 2 7.1678 0.492927 17.521 -0.448362 -6.22938 -12.6047 -417 2 6.39207 1.1517 18.718 17.8505 -10.612 -11.3067 -418 1 15.9607 18.375 13.9642 -35.6371 5.35013 -16.5011 -419 2 15.0008 18.4642 13.7578 26.2499 -2.51915 -0.30366 -420 2 16.0214 0.00880953 14.871 6.50934 -2.46523 19.0717 -421 1 10.2176 4.60873 16.2514 5.45645 -16.296 -9.2455 -422 2 11.1834 4.4434 16.3559 -20.4013 6.80033 -5.0518 -423 2 9.84346 3.80184 15.8357 11.7075 10.859 12.3241 -424 1 15.9288 17.6854 4.49702 -25.8895 1.84686 -2.2825 -425 2 16.5611 18.3979 4.49336 8.57016 10.0602 -1.14853 -426 2 15.0697 18.092 4.72548 12.7214 -6.58434 0.45321 -427 1 6.97646 17.4765 13.8835 1.51347 6.32825 6.74987 -428 2 7.46829 17.7625 14.676 -2.92413 -3.08896 -9.25103 -429 2 7.63479 17.4162 13.1781 -0.793447 -1.23312 2.0982 -430 1 13.2369 6.46193 6.55272 7.97686 -7.07829 -14.9633 -431 2 14.2045 6.47863 6.50403 -7.11621 7.88379 2.07663 -432 2 12.9571 6.40302 5.61769 -2.27464 -2.27743 14.9713 -433 1 7.84752 2.28013 9.41028 -8.73892 -0.731414 -17.5278 -434 2 7.29261 2.26329 10.1936 -2.39479 -1.12016 7.77392 -435 2 7.27021 1.99883 8.67538 7.42107 2.89864 6.55304 -436 1 15.163 14.8378 13.7075 -5.08255 6.9114 -1.94911 -437 2 14.828 14.9803 14.5966 0.517852 0.790599 5.03408 -438 2 14.8205 15.5736 13.1818 1.46712 -6.90646 -0.613497 -439 1 9.40195 8.33905 3.81803 -16.6236 -1.1153 -3.723 -440 2 10.1861 8.88666 3.81624 11.7714 1.21262 5.85608 -441 2 9.65895 7.42947 4.01423 -0.646232 2.08147 -2.76231 -442 1 17.7496 13.6056 16.4496 1.61536 7.2683 -6.30775 -443 2 16.7925 13.5164 16.4445 -3.33508 -5.74033 1.31806 -444 2 17.9176 14.3949 15.9026 -1.24178 -7.25826 8.29135 -445 1 4.89231 10.51 2.8606 23.2586 -26.6571 -20.5821 -446 2 5.63741 10.0083 3.24852 -7.78968 12.4235 -4.83768 -447 2 4.54582 11.03 3.56787 -4.03679 11.8248 12.8852 -448 1 3.69823 8.4002 10.0127 -3.60192 -11.2793 13.5005 -449 2 3.83759 9.3113 9.76164 0.279778 8.83932 -1.11316 -450 2 3.64192 8.42085 10.9836 -1.53751 -1.28356 -9.75822 -451 1 15.9467 6.92332 5.94112 11.8737 -8.24502 3.37919 -452 2 16.7476 7.39494 6.19571 -0.497479 1.69122 3.51528 -453 2 16.2467 6.02535 5.70675 -5.68891 13.7396 -0.851978 -454 1 15.1658 7.18492 9.0507 -10.4703 -15.8706 0.47552 -455 2 15.9236 7.59272 9.46168 11.862 8.93317 3.67812 -456 2 14.9906 7.60382 8.20629 4.02444 8.70872 -4.23998 -457 1 6.21618 12.8841 12.7284 -3.21766 12.2709 11.5322 -458 2 6.77909 12.207 13.0973 14.7659 -5.65099 1.01901 -459 2 6.15827 13.5741 13.4151 -3.2657 -3.93324 -9.28774 -460 1 12.1165 4.51288 13.1048 -1.62418 -0.0716723 20.7898 -461 2 12.3817 4.58382 14.0419 2.18295 3.85449 -11.1604 -462 2 11.2475 4.10019 13.1569 -0.321339 -3.45694 -9.73345 -463 1 11.4166 8.11249 7.92599 8.37678 -3.86112 -10.8327 -464 2 12.0468 7.60844 7.37796 -5.38848 4.21425 7.2331 -465 2 11.8428 8.18692 8.79136 -5.59584 -0.0130509 -4.24997 -466 1 17.091 10.8655 7.57222 -5.5019 -10.6926 10.9756 -467 2 17.8562 10.3128 7.37833 -2.02493 -0.998523 -7.2616 -468 2 16.8515 11.3839 6.80089 6.08197 4.8342 -8.48749 -469 1 5.2937 18.1227 10.8823 3.58086 -4.72457 -4.80722 -470 2 4.89277 17.7527 11.67 -2.28546 -3.10604 1.32943 -471 2 4.67512 17.9479 10.167 -5.31481 4.288 -3.34371 -472 1 7.59808 17.4966 1.71058 0.398559 1.64094 13.9409 -473 2 7.8828 16.705 1.25288 5.11743 -4.18927 -7.63945 -474 2 7.62118 18.2252 1.08608 -3.03358 1.0728 -8.8916 -475 1 1.91712 12.8862 13.5909 8.98798 9.32187 -3.03347 -476 2 1.48166 12.3531 14.2581 -2.09819 -2.06604 3.51643 -477 2 2.30811 13.6552 14.041 -7.16378 -5.11315 -1.13098 -478 1 9.42828 6.75322 14.7826 20.1915 -11.5504 -11.1057 -479 2 9.8277 5.94835 15.1588 -6.88663 6.02054 3.69259 -480 2 9.80073 6.79406 13.8821 -8.1098 8.28496 9.35183 -481 1 15.2968 4.25709 10.7854 2.83104 8.23395 -4.89519 -482 2 16.2313 4.08269 10.6128 -5.94582 -2.20316 7.08238 -483 2 15.3124 5.02999 11.3646 -3.5924 -3.42311 1.83328 -484 1 11.2927 6.22318 0.123361 12.5475 12.622 0.859144 -485 2 11.5233 5.29113 18.7512 -7.74436 -5.44097 -5.24926 -486 2 10.3808 6.34995 18.4806 -0.327163 -9.85792 5.03233 -487 1 18.5472 11.423 14.9732 18.3726 -20.3084 16.0571 -488 2 18.105 11.7915 14.2257 -13.2839 12.4126 -20.1368 -489 2 18.4564 12.0929 15.6514 -4.79118 8.10765 5.85542 -490 1 7.00881 9.27577 7.32015 -11.3868 -9.38104 -0.512081 -491 2 6.68278 8.41602 7.64312 1.53223 10.0212 -0.264373 -492 2 7.94615 9.16913 7.19167 13.4366 -2.83724 0.374421 -493 1 18.3388 15.3149 12.278 7.79295 4.11927 0.907342 -494 2 0.562248 15.7272 12.1255 -3.32497 -4.13752 -3.12696 -495 2 17.7171 15.7348 11.6722 2.18188 4.14775 -1.5511 -496 1 16.4968 4.40066 5.28798 -9.94208 -5.06851 -0.773295 -497 2 16.7853 4.2225 6.18546 2.9967 -3.39819 7.99443 -498 2 17.2662 4.33461 4.72457 15.1936 4.75592 -3.34352 -499 1 17.7173 3.18772 10.7866 10.4448 7.42964 -1.18609 -500 2 18.6422 3.37989 10.9855 -1.52891 3.674 4.44234 -501 2 17.7488 2.39891 10.2588 -4.04978 -15.6839 -7.32077 -502 1 12.3149 18.6145 10.0881 -2.22129 4.11252 3.54852 -503 2 11.4444 0.333084 10.2939 -3.02626 -1.86973 1.00626 -504 2 12.9201 0.705852 10.2372 4.71846 0.03299 -1.96706 -505 1 10.3684 9.76179 12.4758 17.9734 4.74974 2.50525 -506 2 11.1916 9.84607 12.9926 -11.8304 0.187235 -1.96375 -507 2 10.3012 8.81681 12.3218 -3.77483 -3.01576 0.0814472 -508 1 0.689392 2.74058 7.08104 -5.98449 10.1616 9.8561 -509 2 0.88859 3.44563 7.72485 0.581102 -9.26818 -8.93017 -510 2 0.974446 1.93578 7.5088 2.3916 -6.77547 7.05728 -511 1 0.277472 15.3259 6.84135 0.228059 -1.31559 -11.5462 -512 2 0.516029 15.5821 7.71821 6.50181 -1.47438 23.8891 -513 2 0.58839 14.4222 6.74639 0.679055 -1.95969 -5.2972 -514 1 17.0529 6.97528 15.0633 10.9144 -7.53558 1.72506 -515 2 17.8201 7.55974 14.9678 -6.11827 1.26888 -1.51964 -516 2 17.4266 6.16431 15.4413 -5.39729 2.11926 -0.659196 -517 1 9.11957 12.4732 8.03484 -32.1356 7.88594 4.6652 -518 2 9.41535 11.8783 7.35952 15.5672 -13.5118 -9.19924 -519 2 8.15954 12.512 7.86156 14.5216 4.72308 9.92056 -520 1 1.18275 1.7303 2.88012 3.13258 6.74516 -6.07855 -521 2 0.990874 2.23802 2.08159 -8.2151 -5.8717 0.0306137 -522 2 1.74436 2.31191 3.39299 4.34337 2.29394 9.11202 -523 1 4.11863 15.0886 9.98721 11.0177 -1.77256 -13.134 -524 2 4.02022 15.2012 9.03136 -3.58336 0.815549 3.23991 -525 2 5.04995 14.8741 10.1041 0.462863 -2.8957 0.615957 -526 1 7.38268 2.21023 14.7219 2.37064 11.9314 4.06902 -527 2 7.04717 1.62795 14.04 0.302375 -0.796384 -5.36483 -528 2 7.78873 2.97247 14.2654 -8.69617 -12.215 6.09363 -529 1 18.4343 14.5687 2.16054 8.35658 -0.618946 0.782777 -530 2 0.682906 14.919 2.34098 -12.2336 -1.59186 -0.620803 -531 2 17.7977 15.2902 2.22089 3.32879 4.73949 -0.959115 -532 1 10.0087 2.72001 12.9057 2.08485 -1.52945 -12.9938 -533 2 10.0412 2.17732 12.096 -1.38389 3.39971 12.264 -534 2 9.25575 3.30628 12.7713 -2.15732 -0.406341 3.704 -535 1 2.9831 8.88024 13.0189 0.952466 11.8173 -3.08609 -536 2 3.31938 9.77893 12.8076 -5.04245 -14.2298 4.61688 -537 2 3.71596 8.41411 13.4449 -4.1112 -0.429279 -5.2011 -538 1 3.20203 8.5912 3.76846 -11.4045 -12.6583 26.9753 -539 2 3.76961 9.22975 3.3591 6.50161 14.1888 -13.0281 -540 2 3.15464 8.85629 4.71231 4.40411 -9.17072 -19.7321 -541 1 5.64764 7.22249 8.60582 -2.45044 -0.628932 2.27153 -542 2 5.55364 6.27099 8.49955 3.15339 -1.29251 -2.67256 -543 2 4.90409 7.47651 9.17344 9.24373 2.45699 -1.73114 -544 1 14.907 1.53023 1.85078 -7.37767 -15.1485 8.29721 -545 2 14.668 2.24872 2.45072 11.5035 7.56218 -5.89301 -546 2 15.6059 1.77377 1.2289 -9.91057 9.46649 1.95684 -547 1 8.55561 15.0845 0.759561 -2.78586 4.97755 1.3099 -548 2 9.2232 15.1059 1.46635 -5.75771 -3.12613 -8.68727 -549 2 7.79979 14.5909 1.11068 3.03755 -1.08449 1.22088 -550 1 15.5064 1.39564 7.20176 -2.04619 -6.07348 -4.735 -551 2 14.846 0.870461 6.73047 4.3658 -0.949999 1.00211 -552 2 15.0733 2.23713 7.35024 -3.19526 7.79987 5.63196 -553 1 4.99693 12.9582 18.4618 -8.43591 -3.95032 12.7964 -554 2 5.427 12.9558 0.691187 -3.21166 1.68806 -6.66553 -555 2 5.5701 13.4759 17.8974 6.4766 -1.03013 -3.5001 -556 1 15.3823 8.61159 18.0651 4.42877 2.22092 -6.07372 -557 2 15.8154 9.23321 17.4587 -2.51695 -7.00562 1.90652 -558 2 15.1591 9.14089 0.186524 -1.03798 5.78876 7.10622 -559 1 12.0334 3.10844 18.3299 11.3082 -20.8993 7.10454 -560 2 12.3341 2.61645 0.471712 -7.66483 12.171 -5.21514 -561 2 12.3614 2.54753 17.6085 -4.58122 9.25845 0.807451 -562 1 13.192 12.7001 5.16537 5.21593 -6.7049 -2.26257 -563 2 13.6127 11.9331 4.74049 -3.39065 6.67562 5.25333 -564 2 13.2679 12.5364 6.11315 0.126366 6.17512 0.133491 -565 1 6.11282 7.21918 0.158665 1.88014 -14.5403 11.0752 -566 2 6.12514 8.17662 18.815 -2.86446 -0.617519 -0.818148 -567 2 5.41227 6.95692 0.781338 0.907384 -1.18964 -10.3034 -568 1 17.7111 15.8907 14.9544 -3.82577 1.28333 3.96962 -569 2 16.7386 15.9987 14.9233 18.3395 -0.0507343 -6.61585 -570 2 18.0408 15.7242 14.0577 -12.1828 1.42979 -0.226855 -571 1 13.1366 0.926204 16.6604 -4.9212 9.87611 -1.92759 -572 2 14.096 0.89187 16.7156 4.29984 -5.34206 5.94224 -573 2 12.8563 0.0335376 16.4436 -2.56348 -3.63873 3.02874 -574 1 10.9184 14.5253 7.38829 1.38398 -2.03118 7.00079 -575 2 10.1136 14.2278 7.85844 13.304 -1.52714 -8.95405 -576 2 11.6006 13.8396 7.51991 -9.17062 7.88742 -1.04716 -577 1 17.6363 8.46247 2.12178 -2.04395 4.31685 9.18728 -578 2 16.787 8.41765 2.58806 4.70486 1.56362 -5.63911 -579 2 17.6123 7.75928 1.47082 0.631216 -3.65047 -4.17578 -580 1 12.4375 7.79355 2.00637 -2.34281 23.5579 2.73553 -581 2 11.9501 8.63365 1.95534 8.51098 -6.49732 1.55884 -582 2 12.0343 7.24559 1.33225 -2.11395 -7.52965 -2.88654 -583 1 12.0451 14.5968 10.4885 2.58602 -10.5702 -25.2135 -584 2 12.3016 14.3716 9.56719 -0.183055 2.34539 21.1217 -585 2 11.1058 14.7694 10.4266 -10.5567 0.791778 1.58055 -586 1 6.78603 6.87835 15.4866 -3.36028 4.68136 22.1121 -587 2 7.71026 7.02894 15.2668 2.14313 -2.1467 -3.22881 -588 2 6.63472 7.41247 16.2893 -0.664868 -8.24615 -12.946 -589 1 7.99755 4.5041 13.3499 24.8278 34.1767 5.68201 -590 2 7.17338 4.66838 12.8997 -9.34484 -1.26894 -9.57598 -591 2 8.42297 5.40326 13.4231 -14.2483 -32.2403 1.51042 -592 1 13.3614 12.2059 14.3726 -2.68828 -3.01756 -2.25781 -593 2 13.124 11.2722 14.2967 -0.0467593 -0.437755 2.8377 -594 2 13.7081 12.4264 13.5024 2.10157 3.54991 -1.69903 -595 1 14.5654 9.5448 7.2719 7.4337 1.87458 1.84958 -596 2 15.4192 9.97446 7.42049 -0.421966 -1.69006 0.109976 -597 2 13.9603 9.96019 7.88547 -6.00597 1.06642 2.40823 -598 1 12.7021 16.8399 3.28406 2.1329 2.22559 -4.89416 -599 2 12.9627 17.2776 4.09814 -1.16793 0.633127 5.57798 -600 2 12.5029 17.5595 2.67417 -2.21511 -1.15635 -1.62469 -601 1 1.01088 7.06774 17.3689 20.0897 -7.47151 2.1243 -602 2 0.171968 6.83932 17.7636 -13.4375 4.7826 3.09836 -603 2 0.861358 7.69882 16.662 -3.49993 1.38105 -6.69635 -604 1 12.9265 4.90969 15.692 -1.72339 7.7777 5.20839 -605 2 13.7461 4.44088 15.8455 2.50132 -9.36464 -4.69309 -606 2 13.1831 5.83499 15.7716 0.254864 4.72294 -0.0726576 -607 1 2.3277 3.38915 5.11911 5.08689 -5.27649 -8.37414 -608 2 1.81648 3.03652 5.84872 -5.99705 -1.71944 1.12123 -609 2 2.79757 4.13118 5.49603 6.03185 12.6803 -1.33855 -610 1 8.22299 10.983 13.6596 -2.68868 6.78672 22.55 -611 2 8.37046 10.9349 14.6227 -7.71168 -0.54916 -12.6902 -612 2 9.06889 10.7219 13.2955 2.07822 -5.6604 -8.58071 -613 1 12.9566 1.54883 13.2404 -6.45532 19.0424 -4.61407 -614 2 13.4436 1.59622 12.409 4.66376 -6.5769 4.30334 -615 2 12.5511 2.44176 13.2892 3.97521 -19.3883 2.5587 -616 1 6.59697 13.6382 2.12308 -19.53 14.6785 -2.92569 -617 2 5.9569 13.9305 2.80289 7.92829 -3.31956 -9.9577 -618 2 7.23585 13.1086 2.59101 5.128 -6.56439 5.02766 -619 1 15.8657 6.47234 12.6041 4.99369 -6.06314 4.28807 -620 2 16.4551 6.98041 12.0348 -2.62867 1.80518 0.0955392 -621 2 16.3109 6.45259 13.4696 -4.62358 3.40022 -7.66147 -622 1 16.7868 0.706192 9.5524 8.10763 10.4692 12.0206 -623 2 16.4993 18.5236 9.95191 3.55616 -11.3811 -4.24312 -624 2 16.3059 0.843102 8.73445 -6.13335 -2.9453 -10.1224 -625 1 6.15553 11.6636 8.28166 8.04937 9.43191 -5.2183 -626 2 5.38812 11.3133 8.7152 -15.4132 0.789816 9.90132 -627 2 6.60546 10.8728 7.99206 7.62403 -6.5238 -2.76924 -628 1 2.80481 8.67956 0.357522 -16.6853 -5.97365 -15.2844 -629 2 2.27492 8.26466 18.2845 10.7138 4.85897 15.9492 -630 2 2.22127 9.36062 0.722932 4.52332 -2.29686 2.25001 -631 1 10.1103 10.3863 6.60128 -6.60242 -1.42487 -6.12592 -632 2 10.6136 9.70804 7.05871 2.40377 -4.05953 3.76861 -633 2 10.2954 10.2785 5.66001 4.13032 2.32994 2.59513 -634 1 6.85077 15.7563 6.70738 -11.7521 -4.07497 3.77538 -635 2 6.99262 16.2462 7.53077 3.71638 -1.24183 -4.26209 -636 2 6.92978 16.3894 5.98454 6.68147 0.141382 -0.214337 -637 1 6.48958 12.9529 5.78988 1.80967 -1.32299 -1.48619 -638 2 6.5811 13.8382 6.15183 4.24501 4.33378 1.70513 -639 2 6.11675 12.413 6.49523 0.159424 2.05888 1.44919 -640 1 16.7629 12.5191 9.71336 -1.62109 -11.3708 1.97787 -641 2 17.0324 11.8284 9.09183 -7.38478 2.50021 2.06117 -642 2 17.4395 13.1763 9.61316 3.98731 12.5093 -0.628579 -643 1 6.20997 2.89816 2.77935 -0.0802363 -5.63791 0.773513 -644 2 6.61167 3.74714 2.54082 -9.15989 -2.58724 -3.98308 -645 2 5.63039 2.60429 2.05445 8.60419 4.25286 3.07741 -646 1 10.7636 3.09526 3.23748 -2.12809 -1.19847 1.63085 -647 2 10.0581 3.70038 3.49376 4.9418 2.80865 -0.749542 -648 2 10.4122 2.60071 2.48751 -0.504171 1.44253 0.108713 -ITEM: TIMESTEP -80 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.8014 6.74321 17.9894 -25.71 0.163943 4.88408 -2 2 7.93592 6.85831 18.4426 18.3019 -2.2716 -9.29 -3 2 8.62145 6.12739 17.2721 4.06901 -0.284928 0.869098 -4 1 0.193099 8.36013 6.75275 5.74913 -14.5769 25.1987 -5 2 0.349094 8.05034 5.86501 -0.249861 0.708817 -17.2091 -6 2 0.558161 7.64099 7.32168 -7.5605 18.9357 -7.69302 -7 1 8.61156 0.29086 6.89037 18.8351 -6.84677 1.91716 -8 2 9.54524 0.192133 6.6105 -17.2936 6.40231 3.46958 -9 2 8.24205 0.986486 6.33979 -0.485036 0.67975 -2.4356 -10 1 6.46061 1.74084 11.7563 18.0716 -9.05138 -10.6926 -11 2 5.90902 2.36746 12.1907 -18.8993 15.6687 11.8916 -12 2 5.86943 1.07894 11.3852 -0.461453 -6.159 1.34784 -13 1 6.94761 5.53992 2.37529 -6.07193 26.0011 19.9509 -14 2 6.56484 5.89454 3.23997 6.76459 -12.0871 -41.8379 -15 2 6.81469 6.2225 1.67437 0.333839 -16.9501 17.8189 -16 1 16.2464 10.2212 16.095 -30.9636 -1.96085 19.7441 -17 2 16.8891 10.4896 15.4774 30.9665 9.88757 -18.0257 -18 2 15.7638 11.031 16.3423 6.62567 -11.9253 -3.68232 -19 1 10.7594 14.9468 2.28506 -10.192 -15.3258 -5.27915 -20 2 10.552 14.3194 2.98639 5.50444 -0.296801 2.35986 -21 2 11.1642 15.6696 2.7411 11.3222 17.7739 6.10774 -22 1 17.1862 8.22111 10.8759 16.4539 0.643281 -9.91552 -23 2 16.576 8.81969 11.3105 -3.64966 6.67804 4.28607 -24 2 17.949 8.77387 10.614 -8.44523 -5.92405 1.0378 -25 1 14.6358 16.0024 16.3895 25.5058 -11.0228 4.42293 -26 2 13.7352 16.2786 16.3126 -22.3429 5.97271 0.576342 -27 2 14.7081 15.5263 17.2386 -3.54281 4.69451 -12.0743 -28 1 12.1273 13.3164 0.564829 -0.361627 4.24339 0.0908299 -29 2 11.7754 13.443 18.3303 1.85705 -5.04776 -15.4247 -30 2 11.6653 13.9884 1.07404 2.42612 -1.45379 10.2607 -31 1 9.30563 5.48822 3.87958 6.5447 0.0363683 25.4904 -32 2 8.87806 5.40536 4.77034 1.54217 -0.907852 -25.4465 -33 2 8.62277 5.52424 3.19838 -5.81373 -1.17005 3.72822 -34 1 1.59219 3.96918 11.5778 -9.84269 42.1113 -23.7424 -35 2 1.65598 4.94531 11.7448 -5.32168 -23.4604 1.30407 -36 2 2.08682 3.52502 12.2368 16.8537 -14.859 24.6718 -37 1 2.0876 6.92307 8.18563 -3.73767 -8.57072 -0.0346284 -38 2 2.39381 7.30463 9.00964 5.23298 7.68032 1.6714 -39 2 2.09597 5.97338 8.35948 -3.7573 0.82597 0.238295 -40 1 5.28961 4.49122 7.85762 -5.23337 8.41869 1.15392 -41 2 5.42981 3.54006 7.92701 -4.09922 -6.37036 -7.26013 -42 2 4.64396 4.70759 7.15783 7.0556 -5.183 4.67383 -43 1 3.36027 2.89954 17.3915 -17.4395 12.4687 22.0366 -44 2 4.05476 3.43419 17.006 5.24509 0.828911 -8.29254 -45 2 2.77379 3.5226 17.8911 18.871 -11.3769 -11.5396 -46 1 7.49453 5.42535 6.18785 1.1565 -0.337813 22.5495 -47 2 7.9164 5.96716 6.90215 -9.87324 -14.4944 -23.4171 -48 2 6.89327 4.79051 6.63979 12.0833 17.318 -7.46699 -49 1 9.81909 7.02563 12.0706 7.31099 -1.858 8.99458 -50 2 10.1534 6.27284 11.5881 4.21769 -4.6772 -1.38273 -51 2 9.09614 7.33889 11.5389 -11.6555 6.63577 -10.586 -52 1 13.987 3.72336 8.09074 -16.8343 16.962 -37.2017 -53 2 13.5442 4.52839 7.7245 12.4076 -19.615 9.33911 -54 2 14.2201 3.91921 8.97962 7.00657 7.67382 26.2916 -55 1 4.5104 17.1281 3.91533 10.7578 31.6451 -21.4766 -56 2 5.3439 17.6347 3.91183 -5.56531 -14.4645 11.3324 -57 2 4.01019 17.58 3.20396 0.717673 -14.6313 13.083 -58 1 16.3456 16.5752 10.4878 9.47486 -6.83722 -28.8723 -59 2 15.5139 16.524 10.9378 -17.3385 1.90191 12.1775 -60 2 16.1667 16.1386 9.62748 3.54118 4.50203 14.5107 -61 1 1.9669 4.78352 0.127126 -0.739304 -4.30462 13.1261 -62 2 2.4124 5.1813 0.904759 -4.07407 -0.50297 -16.3737 -63 2 1.70825 5.48663 18.1668 4.40273 7.87995 3.28325 -64 1 11.3312 13.2592 16.4181 -1.15069 -16.7597 -15.9919 -65 2 10.8158 12.4247 16.4648 10.4615 17.429 3.38388 -66 2 11.9137 13.1122 15.6483 -5.75273 4.84583 10.0297 -67 1 10.0951 10.9476 16.7865 12.4257 -21.5163 1.40398 -68 2 10.4762 10.0399 16.7888 -6.98476 25.4172 2.00859 -69 2 9.15392 10.8219 16.7533 -12.5538 0.302602 -1.38706 -70 1 11.8287 17.486 13.4829 -0.118354 -13.6364 7.15806 -71 2 12.4458 16.8683 13.0504 -5.40922 13.24 -3.88075 -72 2 12.1685 18.3769 13.3708 4.2975 6.3924 -3.60834 -73 1 6.40329 9.45666 12.3007 7.59953 -15.5921 -26.3915 -74 2 7.02951 9.14458 11.6116 -13.6176 6.52201 11.0115 -75 2 6.95635 9.88774 12.9378 9.38595 10.7935 13.1394 -76 1 16.3024 12.9052 2.74142 -15.9403 -16.7132 8.77179 -77 2 17.1501 13.3041 2.5727 9.16723 7.57391 -3.15506 -78 2 15.6647 13.6204 2.85813 1.6204 2.22565 -2.39426 -79 1 0.760847 12.751 5.87222 -24.7031 -12.948 -13.3423 -80 2 1.12648 12.6956 4.9713 -1.82207 2.12621 9.26767 -81 2 18.4428 12.5289 5.74368 26.1358 12.2861 6.31515 -82 1 5.29492 16.3822 18.4146 -5.77927 -1.1636 -2.25588 -83 2 5.45161 15.4933 18.0434 4.5004 13.3336 10.181 -84 2 5.72207 16.4863 0.6292 0.349856 -6.54957 -3.00829 -85 1 0.672446 7.71977 4.17015 11.9206 5.83738 -2.65809 -86 2 0.0599114 7.99601 3.47788 2.17241 0.0211014 0.560686 -87 2 1.51354 8.18303 3.96741 -13.409 -12.9126 0.0558484 -88 1 3.18041 9.04016 6.47644 -48.733 9.26031 0.132627 -89 2 3.67612 8.69495 7.19851 13.8171 -10.3779 15.348 -90 2 2.22175 8.86945 6.71565 32.4894 5.10639 -10.1715 -91 1 7.33809 10.425 16.1982 -13.7714 -1.76245 23.4597 -92 2 6.52669 10.798 15.8343 6.52641 -1.5478 0.375626 -93 2 7.11414 10.2397 17.1395 3.58358 2.1532 -21.3577 -94 1 11.0368 0.910412 5.00755 -5.03762 -2.37072 -20.9965 -95 2 11.0166 1.76948 4.5572 3.99116 -0.122414 9.27702 -96 2 10.8085 0.318039 4.26499 2.41704 1.78329 12.9529 -97 1 4.27055 2.90822 13.1584 -5.03414 2.69466 11.7405 -98 2 4.39065 3.48249 13.9384 2.16314 -12.4788 -5.29849 -99 2 4.11656 2.00207 13.4974 4.2297 10.0998 -5.7581 -100 1 8.47529 10.248 1.79037 -0.416679 -17.2671 7.19176 -101 2 8.23967 10.8662 2.49257 2.8179 1.08296 2.51337 -102 2 8.59639 9.37915 2.23271 0.0130336 16.1865 -5.8343 -103 1 10.3383 1.70852 15.4843 -18.7352 2.46602 -2.29408 -104 2 11.1863 1.36274 15.7269 17.9639 -3.17473 -1.31836 -105 2 10.261 1.74525 14.5183 4.02029 2.26456 4.98686 -106 1 2.61381 12.97 7.91629 0.377646 -9.00714 -10.2558 -107 2 3.20736 13.521 7.38885 -1.73045 4.27865 2.80704 -108 2 1.92972 12.6563 7.30106 5.76016 2.06086 0.889789 -109 1 3.8265 11.6489 4.94253 -18.049 0.292651 15.0893 -110 2 3.64515 11.1228 5.74952 0.240622 6.04317 -17.8646 -111 2 3.00147 11.7074 4.41136 14.7829 -0.870145 11.9003 -112 1 6.67003 14.5068 16.9871 0.195301 -8.52391 -8.20479 -113 2 7.30673 15.1853 17.2075 3.81359 1.00594 1.02421 -114 2 6.51415 14.5784 16.0351 -3.74805 4.58221 3.23833 -115 1 14.2005 14.4991 3.2542 12.2104 -4.1759 -13.149 -116 2 13.9664 15.4191 3.35064 -8.52353 7.22912 -0.280994 -117 2 13.8358 14.0368 4.00136 -6.61808 -5.66537 10.7242 -118 1 8.64986 18.0488 16.0994 -35.3958 -9.60596 -0.188096 -119 2 9.08138 17.255 16.4541 14.3634 13.9351 -5.51429 -120 2 9.16615 0.19969 15.9552 18.9441 -0.541676 3.30098 -121 1 4.69447 1.75392 4.88991 25.859 26.3088 -12.7751 -122 2 3.87089 2.24691 4.93296 -3.58784 0.203107 2.94233 -123 2 5.32887 2.35869 4.40805 -22.2668 -23.8988 10.2256 -124 1 15.0337 12.5563 16.5322 -9.42235 19.0778 45.1845 -125 2 14.5415 12.8308 17.3429 25.2588 -5.91919 -13.7907 -126 2 14.3516 12.6025 15.8912 -15.7131 -4.7436 -33.7881 -127 1 15.7107 18.4933 16.8499 14.0119 15.6823 26.0515 -128 2 16.2364 18.5256 17.6977 -11.7154 -4.95338 -28.5838 -129 2 15.2517 17.6535 16.8181 2.70767 -12.4638 1.72062 -130 1 1.36288 1.31672 16.6317 -8.11361 12.6727 12.78 -131 2 2.12452 1.88684 16.8387 -7.41596 -12.3761 -6.73343 -132 2 0.666274 1.64987 17.2352 10.0682 -8.10993 -10.4284 -133 1 18.2119 4.36953 15.9172 -1.70541 -5.24792 -22.7614 -134 2 17.9042 3.81192 15.1707 6.44647 9.66147 16.3107 -135 2 0.476259 4.62247 15.7042 -5.76089 -2.38794 2.9761 -136 1 12.1484 17.0613 16.1489 -25.1744 -26.2572 32.1897 -137 2 11.4087 16.4938 16.5203 28.1495 25.8696 -8.33389 -138 2 11.9925 17.0682 15.2174 -4.06343 5.18838 -23.7308 -139 1 16.1307 2.63053 18.236 -24.4255 7.46546 -12.7341 -140 2 15.654 3.45006 18.4862 10.3096 -12.6534 -4.96798 -141 2 15.8825 2.42572 17.3162 0.942238 5.76458 9.76029 -142 1 6.69125 13.7819 10.0957 6.51523 5.30674 14.72 -143 2 6.68166 13.4115 10.9958 -3.31201 0.605957 -8.104 -144 2 6.74207 13.0463 9.48799 -5.76864 -9.77159 -4.40801 -145 1 10.1909 18.4566 2.69612 24.6552 12.5235 -11.9688 -146 2 10.5208 0.299966 1.90483 -6.63917 -6.88653 20.5003 -147 2 9.33855 18.1401 2.45819 -23.0922 -9.86885 -6.30041 -148 1 3.05041 17.6833 6.1612 -20.7399 0.346779 9.3758 -149 2 2.11766 17.6882 5.81771 32.7543 -5.44367 1.96306 -150 2 3.663 17.6288 5.4193 -6.60477 0.357372 -5.21379 -151 1 12.6301 16.8021 7.91443 2.73044 3.22351 -7.20597 -152 2 11.8394 16.2829 7.68186 3.48899 3.70212 12.2186 -153 2 12.4619 17.4281 8.63963 -10.075 -5.48551 -5.536 -154 1 14.8863 15.2402 8.20999 -23.6436 14.8183 29.3151 -155 2 14.1404 15.8836 8.27066 14.7388 -14.8318 -6.56535 -156 2 15.2763 15.3549 7.35467 9.52302 6.19548 -12.651 -157 1 17.8321 18.2493 0.273835 -34.2521 -9.59248 -4.32979 -158 2 18.5224 17.6645 -0.0392514 10.753 2.02465 3.4369 -159 2 18.2087 0.412934 0.595185 14.0613 13.0178 4.00109 -160 1 0.763956 10.5262 1.39925 -10.0074 -57.9186 33.1602 -161 2 0.0205775 9.86382 1.5781 27.9288 29.6193 -5.5527 -162 2 0.446448 11.1766 0.811593 -14.5912 25.5328 -23.4764 -163 1 1.80037 12.2889 3.30512 5.17734 11.597 19.2466 -164 2 1.46139 11.5987 2.74824 -6.10095 -9.75588 -16.5262 -165 2 2.13675 13.0044 2.75129 -3.9772 -2.70365 -1.85909 -166 1 0.682885 17.2588 4.99366 18.5034 24.5267 -32.7679 -167 2 0.107172 18.0117 5.16246 -8.54671 -5.12892 6.2039 -168 2 0.50047 16.4742 5.48014 -13.5055 -14.6224 21.6265 -169 1 1.0645 0.823506 9.34737 11.8193 5.83131 5.68962 -170 2 1.36557 0.594309 10.2448 -8.52979 0.55273 -0.975829 -171 2 0.153783 0.559257 9.28231 -13.2671 -5.76719 2.40467 -172 1 16.771 2.35127 13.3608 4.58635 29.8799 -13.6101 -173 2 16.8279 2.7166 12.4388 1.57782 -15.3367 24.752 -174 2 16.4858 1.44141 13.3191 -2.28737 -11.3359 -2.05688 -175 1 2.68433 15.9539 12.0479 2.00481 -8.12072 21.99 -176 2 2.97356 15.5639 12.9056 -4.45908 8.74231 -22.8774 -177 2 3.1524 15.4962 11.3314 -4.16555 3.83231 7.28649 -178 1 16.3902 15.5703 6.15458 18.8333 21.1033 -24.533 -179 2 17.3221 15.5371 6.43733 -15.6071 -4.56317 -0.523174 -180 2 16.3697 16.3474 5.53712 -7.15193 -24.3314 15.8574 -181 1 5.78808 5.16844 11.811 1.07675 -5.38543 -7.05048 -182 2 5.68145 6.03537 12.2081 -3.48533 4.06917 4.5041 -183 2 5.0592 4.65006 12.1655 2.16361 -4.54815 -2.94322 -184 1 15.172 4.89144 0.795633 -0.620892 -0.594882 26.39 -185 2 14.9156 4.81116 1.75201 7.19669 -4.64536 -26.7766 -186 2 14.3985 5.20255 0.336699 -8.8444 5.20324 -3.46854 -187 1 16.3986 16.4119 1.90339 15.122 14.6556 -26.5352 -188 2 16.0454 16.7612 2.71133 -6.27107 5.29423 17.303 -189 2 16.8063 17.1873 1.44657 -8.45441 -18.3773 8.08233 -190 1 0.184762 4.82044 3.92309 -20.0167 36.2337 -7.4234 -191 2 0.305381 5.80234 3.92557 1.42835 -23.0136 0.864842 -192 2 1.01251 4.4465 4.18098 17.0496 -9.16948 9.65169 -193 1 2.95853 15.072 15.1235 -0.929158 -18.0667 1.08146 -194 2 2.81752 14.526 15.9315 -1.93517 21.6459 -9.19578 -195 2 2.47159 15.9015 15.2035 -0.281788 -0.150795 8.17547 -196 1 1.08884 14.6409 9.4443 27.3966 -12.5379 -34.1186 -197 2 1.70575 13.947 9.05916 -23.9186 28.888 17.798 -198 2 0.66831 14.2301 10.1769 -7.64803 -12.9163 21.0233 -199 1 13.5173 16.5215 11.5364 0.489599 15.4909 -5.38356 -200 2 13.0836 17.2895 11.1076 8.88627 -7.75363 7.54599 -201 2 13.0704 15.7764 11.1287 -2.36322 -6.26123 2.87696 -202 1 4.73898 1.52078 0.69167 -9.68217 -10.6702 17.6377 -203 2 4.07875 2.00526 0.184075 4.46446 1.98443 -3.98397 -204 2 4.22033 0.928191 1.27988 9.48282 8.28471 -14.387 -205 1 1.52478 18.5784 11.9214 -16.2358 21.4234 -4.1613 -206 2 1.51367 0.493465 12.7143 -0.730917 -3.29007 -5.80239 -207 2 2.22048 17.951 12.0321 13.8924 -17.5303 6.45556 -208 1 11.4148 10.1041 4.08036 9.63761 14.6797 -7.17105 -209 2 11.6092 10.6619 3.28786 -9.14527 -18.7957 16.2306 -210 2 12.2661 9.96891 4.5224 -0.931524 1.73008 -8.63915 -211 1 8.18373 12.2132 3.70486 4.04638 8.18109 41.2935 -212 2 9.0456 12.58 3.98139 -6.62274 -6.35725 -9.04284 -213 2 7.64552 12.2934 4.54 8.66084 -3.68417 -28.5646 -214 1 14.5934 4.00277 3.33714 14.4882 6.32576 -0.110592 -215 2 15.3087 4.27672 3.93937 -11.245 -6.6719 -0.591331 -216 2 13.7777 4.36055 3.68688 -6.37652 3.17854 3.04506 -217 1 5.71814 1.6621 7.57513 -5.5313 -4.02265 40.0153 -218 2 5.00295 1.12677 7.97081 8.59667 7.25176 -1.51046 -219 2 5.48447 1.71188 6.6706 -7.03261 -0.519715 -37.0679 -220 1 17.8819 0.996597 4.84385 3.28334 1.22129 -8.70029 -221 2 18.3735 1.40853 4.10428 -5.78677 -2.02928 14.9184 -222 2 17.7642 1.64161 5.55539 2.20556 -0.0657175 -7.03701 -223 1 6.81886 9.28778 4.52861 6.25722 -6.76526 -10.2791 -224 2 6.61832 9.39383 5.45723 -0.00817066 1.76549 8.49843 -225 2 7.7574 9.04758 4.4954 -4.05712 -0.0763234 -2.03313 -226 1 2.4854 14.759 2.04442 -7.64745 -7.92423 -28.9185 -227 2 3.31932 14.7218 2.51092 7.63377 -1.04104 5.23896 -228 2 2.65881 14.5612 1.09422 1.17207 5.04057 23.1132 -229 1 17.2643 12.9213 13.1026 -19.9619 15.9168 2.25648 -230 2 16.3761 13.2301 13.4207 25.7036 -1.66639 -12.6722 -231 2 17.7779 13.7212 12.8621 -11.3949 -9.92691 5.05246 -232 1 14.8558 10.5579 1.44832 -24.1837 -11.6243 -0.0449549 -233 2 15.2498 11.3496 1.79784 9.85962 12.147 5.79114 -234 2 13.9164 10.5877 1.7065 14.7293 1.68269 -5.02708 -235 1 5.67033 6.62258 4.57309 8.95784 -16.3381 4.76769 -236 2 5.78141 7.53495 4.33529 5.34224 19.3995 0.612293 -237 2 6.44538 6.37316 5.11369 -12.1071 3.69782 0.132968 -238 1 8.08484 8.3464 10.3723 -2.79238 1.81559 10.704 -239 2 8.60215 8.86766 9.74634 -1.18548 0.238269 1.84293 -240 2 7.34937 7.94467 9.9053 0.580319 -4.15939 -10.1337 -241 1 13.4382 18.465 5.66883 -2.12963 -16.204 3.95429 -242 2 12.6402 0.317353 5.43723 -0.0049589 1.74147 2.86213 -243 2 13.1409 17.7635 6.28441 4.99057 13.7489 -2.35078 -244 1 -0.0389125 2.60201 0.358484 20.6019 -11.619 5.06808 -245 2 17.6744 2.57403 18.7483 8.04315 12.368 -1.45646 -246 2 0.347515 3.47455 0.194182 -8.07269 -1.54831 -1.2857 -247 1 12.9609 10.9078 9.72363 -44.1168 29.5082 -8.54535 -248 2 11.9486 10.9818 9.7709 44.2995 -10.8859 -2.13595 -249 2 13.1901 10.0051 9.91101 -8.5598 -18.2315 3.87517 -250 1 0.590645 12.1909 11.1498 11.7969 16.2942 20.6903 -251 2 18.3214 12.2032 11.4307 -13.062 -2.39731 -5.9775 -252 2 1.05781 12.4788 11.9545 1.3761 -3.96073 -11.1532 -253 1 5.19979 7.35251 13.3459 4.96104 -3.5954 0.621761 -254 2 5.77554 8.05147 13.0099 -6.36891 3.58923 -1.12306 -255 2 5.62026 7.07364 14.1664 0.643961 -0.709679 0.08133 -256 1 1.17273 6.78721 11.9743 -37.7935 -22.2758 -19.6174 -257 2 0.361865 7.16229 11.5551 20.1673 -8.51661 10.9701 -258 2 1.7013 7.51605 12.2195 19.7686 31.2325 8.39364 -259 1 15.5313 9.74152 12.3525 -7.42661 26.8763 14.1834 -260 2 15.1354 10.6339 12.1691 17.2848 -32.3992 2.44097 -261 2 15.9001 9.83422 13.2442 -4.7827 -6.0868 -10.0384 -262 1 16.5842 12.6457 5.58229 -7.58554 26.2756 -26.1768 -263 2 16.3849 13.5701 5.8413 5.71516 -14.5282 0.0223018 -264 2 16.4193 12.6729 4.60395 6.10391 -10.0799 23.5706 -265 1 6.38601 9.81704 0.0456579 -23.7849 0.890546 -8.41533 -266 2 5.51671 10.1854 0.278669 9.54818 -0.234306 -0.813632 -267 2 7.00687 10.1562 0.67255 15.5644 7.03716 17.2844 -268 1 12.2684 6.05846 4.00919 -28.2934 -33.3926 21.5663 -269 2 12.263 6.7861 3.41661 0.234348 22.4834 -18.769 -270 2 11.3224 5.76736 4.06199 25.4812 4.82389 -2.50319 -271 1 0.373791 12.8792 0.072054 -11.107 3.80906 -1.77299 -272 2 18.9015 13.5268 0.779758 -5.73011 -3.33995 1.31101 -273 2 18.3694 13.1354 18.0395 6.43374 -1.82904 2.53089 -274 1 3.55692 18.7013 8.65073 14.893 -16.0199 -12.5754 -275 2 3.38339 18.1698 7.85699 7.36237 7.58391 1.53928 -276 2 2.68044 0.23403 8.96368 -11.3363 8.83032 5.06178 -277 1 7.32525 17.3963 4.4514 17.4309 29.7426 -3.23332 -278 2 7.82401 18.2131 4.74166 -23.0386 -26.7058 -8.39786 -279 2 7.43189 17.3694 3.48275 -1.39589 -2.42936 11.5599 -280 1 9.26525 17.1572 12.169 8.13396 -3.40366 20.592 -281 2 9.29678 16.2438 11.8433 -0.925088 7.81756 -3.33389 -282 2 9.96734 17.2329 12.8546 -10.0311 -2.0771 -17.5408 -283 1 13.2786 13.1508 8.01112 -12.5044 -28.1533 13.0431 -284 2 13.4287 12.5256 8.7581 -3.83031 10.1919 -19.0767 -285 2 13.9208 13.8439 8.10408 14.3758 9.62768 2.82629 -286 1 14.7717 2.95063 15.4663 23.0059 6.37496 -12.5686 -287 2 14.1149 2.31 15.1961 -5.56432 -5.96018 -2.11564 -288 2 15.3514 3.08539 14.6861 -8.35989 -8.63193 12.4086 -289 1 9.95789 15.6422 16.9764 -4.46993 0.793564 -8.8018 -290 2 10.2307 14.8148 16.5569 1.31144 -2.42354 4.42353 -291 2 9.44172 15.4 17.7473 1.0906 -3.95706 9.45227 -292 1 11.2531 8.54113 16.6333 5.17657 0.0418295 -8.84929 -293 2 10.6325 8.00272 16.1399 -5.6117 -5.11655 -0.169214 -294 2 11.5912 7.9918 17.3372 0.751532 -6.83429 5.96975 -295 1 4.09617 18.2775 16.8038 -1.75476 28.7193 2.74196 -296 2 4.5979 17.7227 17.3968 3.26159 -10.0112 3.6984 -297 2 4.13851 0.526798 17.2077 -3.53746 -18.1625 -9.44923 -298 1 2.30039 4.26982 8.91686 21.6694 -5.11589 23.5763 -299 2 3.26852 4.19272 8.75344 -21.2665 0.643644 3.82423 -300 2 2.17319 4.0769 9.88449 2.25335 4.47185 -28.5355 -301 1 9.91449 10.4045 9.82138 -1.36818 12.3774 -23.5261 -302 2 9.54718 11.2486 9.48103 5.13969 -13.6804 7.80682 -303 2 9.93694 10.4191 10.7736 0.214264 3.33848 13.7587 -304 1 9.74784 0.927945 10.8307 17.8645 8.52415 0.395599 -305 2 9.30432 0.217271 11.2949 -5.1784 -7.81016 -3.03012 -306 2 9.13824 1.32484 10.1982 -3.45577 -3.9008 2.04599 -307 1 9.17195 15.1281 10.2005 -15.5022 -1.44929 -2.09464 -308 2 8.96814 15.9769 9.77108 -2.08214 -7.76738 2.59404 -309 2 8.35001 14.5895 10.1068 18.2617 13.451 2.66111 -310 1 0.828362 9.74081 10.2167 22.8302 -4.53826 -35.6406 -311 2 0.863435 10.6794 10.4661 0.846835 -12.3508 -3.07098 -312 2 1.42185 9.63122 9.40918 -26.8549 6.26386 38.0517 -313 1 17.1622 4.86379 8.08044 2.41554 -11.1764 16.204 -314 2 16.3163 5.29453 8.26848 4.74994 -0.845127 5.21041 -315 2 17.4172 4.31929 8.8662 -8.72341 14.5987 -22.1578 -316 1 14.8039 14.6747 0.0449816 -17.091 -7.62196 19.0468 -317 2 15.3137 15.169 0.695817 3.50252 1.08273 0.82912 -318 2 14.0068 14.3765 0.533797 12.6241 2.78049 -10.2188 -319 1 3.85026 11.0642 9.5563 -2.44831 7.24975 -16.8488 -320 2 3.90516 11.4403 10.4374 -3.64435 1.57263 7.30128 -321 2 3.45144 11.7342 8.96857 -1.60708 -4.46554 10.9787 -322 1 11.3552 10.7376 1.50363 23.7004 17.8717 -7.90317 -323 2 11.5499 11.5913 1.05012 -4.60225 -16.5984 9.56505 -324 2 10.4091 10.6312 1.49605 -14.4596 -0.264671 -3.06241 -325 1 13.1456 7.20328 12.6021 -24.9249 -2.39855 5.22786 -326 2 14.066 6.96941 12.5913 17.2615 -6.20786 -1.13088 -327 2 12.6433 6.37391 12.7221 9.22616 8.00521 -2.5813 -328 1 9.63635 1.93928 0.908954 12.9918 3.25798 9.3487 -329 2 8.80616 1.72326 0.497356 -10.689 -0.461065 -8.23177 -330 2 10.2384 2.2422 0.224542 -0.105661 1.67982 -4.44056 -331 1 10.6547 13.4406 4.52244 4.65594 3.65244 26.3326 -332 2 11.5391 13.0824 4.73514 -13.2197 2.26822 -8.08889 -333 2 10.4444 13.96 5.32492 0.722291 -5.69425 -12.9779 -334 1 14.5068 1.61853 10.9473 1.56188 14.5139 4.90111 -335 2 15.3059 1.27791 10.528 -0.453964 2.70191 1.23402 -336 2 14.6742 2.57144 11.1203 -1.66622 -13.4066 -10.2612 -337 1 14.4999 12.0198 11.6401 -20.4 4.4823 -10.6844 -338 2 15.1901 12.5044 11.1683 0.00955556 -6.20474 -4.10181 -339 2 13.88 11.6279 10.9736 17.9431 15.8984 14.8698 -340 1 8.17874 5.12415 9.82106 -30.5984 10.5693 18.9492 -341 2 7.28241 5.07355 10.2519 27.6442 5.22023 -11.9731 -342 2 8.30253 4.26697 9.4335 2.62166 -17.6444 -4.58757 -343 1 1.47714 16.9429 18.4887 13.3148 33.7663 -28.6254 -344 2 1.86682 17.2437 17.6257 -9.89818 -8.00998 25.1444 -345 2 1.74527 16.0479 18.574 6.31239 -26.8006 -0.778427 -346 1 1.45374 17.3594 15.3268 42.8952 -1.15706 -0.811193 -347 2 1.42588 18.2136 15.749 -3.30828 11.7666 5.73369 -348 2 0.584657 17.0429 15.2318 -41.4551 -8.54136 -0.705167 -349 1 3.54007 5.76039 6.04888 -8.98595 6.80975 7.90297 -350 2 3.01039 6.43039 6.5207 7.85999 -10.8756 -2.65394 -351 2 4.1622 6.27284 5.52252 1.18276 -3.83664 -2.43702 -352 1 12.5413 9.50789 14.2278 14.1386 -34.2774 -1.94842 -353 2 12.9806 8.74877 13.7665 -10.1246 23.4373 5.48687 -354 2 12.3781 9.12309 15.104 -2.49329 10.5308 -3.54938 -355 1 4.07791 15.2392 7.05947 28.2061 -4.52306 7.60827 -356 2 3.62905 16.0551 6.82 -1.6925 3.55103 -3.37365 -357 2 5.05246 15.4367 7.04645 -25.4492 -3.49557 -3.60676 -358 1 0.767125 8.74429 15.1186 -1.35051 -1.02403 -4.71838 -359 2 0.502685 9.67668 15.1423 2.70563 -3.13172 -3.80763 -360 2 1.44028 8.65803 14.4206 -5.36892 5.64782 6.7911 -361 1 12.8556 8.29114 10.1154 40.5883 -11.1151 11.7349 -362 2 13.7543 7.93714 9.90509 -23.2563 4.30646 -4.77873 -363 2 12.8036 8.10553 11.059 -7.7965 -1.57596 0.639248 -364 1 15.3061 7.91627 3.47282 -42.6646 -27.0181 14.5138 -365 2 14.4087 7.67951 3.19876 7.83283 16.2655 -25.9683 -366 2 15.288 7.37548 4.27198 30.0578 14.5578 6.00353 -367 1 17.2193 6.75387 0.0348868 -24.2654 8.60155 -9.76068 -368 2 16.7331 5.97981 0.339573 3.08011 -1.47023 2.02216 -369 2 16.4984 7.35116 18.3587 20.6605 -10.5931 7.39935 -370 1 8.96527 6.96977 7.82312 -33.6536 -16.7811 13.5927 -371 2 9.86459 7.23854 7.79988 29.8916 7.79708 0.58286 -372 2 8.85329 6.36072 8.58482 2.84704 12.8992 -8.98126 -373 1 12.4369 0.615517 1.24835 5.12967 -8.6669 -10.2958 -374 2 13.1996 1.14046 1.50868 5.63 -3.81589 5.32704 -375 2 12.6841 0.248493 0.387703 -6.12727 4.87774 5.89397 -376 1 5.63437 15.0947 14.482 15.2573 18.1506 -1.5187 -377 2 4.74012 15.1756 14.8216 -5.87791 -1.19647 -0.853033 -378 2 5.96659 16.0211 14.4028 -4.19512 -21.3346 -4.32131 -379 1 3.78146 6.44452 1.71439 -10.0957 17.3086 -10.1533 -380 2 3.36154 7.20469 1.26344 3.84289 -8.07011 2.3383 -381 2 3.80108 6.73559 2.62781 1.97525 -3.80667 6.02801 -382 1 3.89131 11.3886 12.3597 10.4858 -4.45626 -8.95185 -383 2 4.75702 11.7925 12.5217 -6.56671 -1.88331 -0.935479 -384 2 3.25208 11.9718 12.7596 -7.39976 8.19237 6.18945 -385 1 5.30831 3.87649 15.7567 -11.2019 61.1278 12.0088 -386 2 6.01892 3.27998 15.6709 29.6235 -28.0721 -9.85567 -387 2 5.7476 4.76544 15.8793 -15.8563 -28.9516 -7.19779 -388 1 14.1175 10.173 4.66017 9.40425 -19.9217 -33.2768 -389 2 14.1461 9.82294 5.54158 6.86029 -3.38102 17.8715 -390 2 14.6328 9.51646 4.11155 -16.0552 24.3993 16.1239 -391 1 7.5636 17.329 9.02789 1.81886 -5.76611 4.78707 -392 2 6.9813 17.6417 9.74433 4.383 2.36677 -11.0761 -393 2 7.91242 18.0661 8.5041 -5.60089 1.56926 3.7162 -394 1 4.54646 14.4437 3.82391 2.35855 8.70422 24.1238 -395 2 4.58695 15.3758 4.17596 -1.73775 -31.732 -9.36156 -396 2 4.50325 13.8127 4.58585 2.14298 18.0212 -18.4803 -397 1 14.2437 7.3639 15.8726 24.9361 2.31774 6.81444 -398 2 15.0991 7.30759 15.3921 -17.5628 0.546592 9.39404 -399 2 14.5002 7.74932 16.7373 -8.89015 -4.19374 -15.8798 -400 1 3.04207 18.4209 1.96748 -18.4085 17.9201 24.7102 -401 2 2.5353 17.8449 1.40649 -4.22111 -10.717 -13.4847 -402 2 2.35407 0.262093 2.48798 16.8127 -9.3976 -15.4809 -403 1 7.96924 1.62215 4.56344 31.9424 -9.467 0.421552 -404 2 7.35201 1.92948 3.90341 -1.64239 4.88827 -11.6355 -405 2 8.85795 1.52282 4.13815 -26.2226 6.52533 8.08337 -406 1 2.457 14.1626 17.6995 -18.6259 -8.83368 10.0969 -407 2 1.68725 13.6009 17.9701 23.9808 13.2635 -8.93306 -408 2 3.24279 13.6711 17.9492 9.2771 -5.34798 1.51385 -409 1 0.927142 1.91914 13.8849 28.4694 2.81528 -14.4963 -410 2 1.17928 1.66855 14.7668 -1.31862 -2.11333 16.1229 -411 2 -0.00784116 2.01924 13.8762 -26.8609 -0.0423979 -2.90492 -412 1 4.3639 0.116891 13.871 19.5154 5.98388 -10.2249 -413 2 5.3312 18.592 13.8382 -18.25 -1.84578 0.0905254 -414 2 4.09014 18.5553 14.7613 -1.68072 -4.35498 12.29 -415 1 7.32185 0.935992 18.4254 -25.1976 4.88188 40.3736 -416 2 7.29261 0.583526 17.5599 3.22929 -13.7772 -30.1977 -417 2 6.39141 0.906009 18.7671 22.6248 8.40202 -10.9225 -418 1 15.9043 18.3822 13.9598 -30.4853 6.92778 -31.02 -419 2 14.9691 18.5865 13.6701 32.1757 -7.76669 18.1984 -420 2 15.9697 -0.290473 14.9111 -4.96086 4.78357 11.6174 -421 1 10.2566 4.62301 16.2429 -20.4053 -21.3362 -19.7333 -422 2 11.1923 4.47268 16.3843 6.75918 3.74651 0.0845893 -423 2 9.94726 3.80759 15.7722 8.97755 19.5704 18.0095 -424 1 15.9188 17.665 4.49409 -30.8876 16.8748 5.69015 -425 2 16.5463 18.3904 4.38809 -0.624131 1.21894 5.03495 -426 2 15.0755 18.0798 4.84388 28.6139 -15.2662 -13.1828 -427 1 6.9464 17.5119 13.903 30.1459 16.134 14.6047 -428 2 7.45538 17.7973 14.7126 -14.438 -11.5296 -22.8133 -429 2 7.62564 17.4897 13.1926 -14.0494 -3.94126 11.1274 -430 1 13.2241 6.43487 6.53037 -11.3028 -4.49966 -3.41689 -431 2 14.1722 6.56035 6.47079 5.41657 3.67276 -3.81812 -432 2 12.8747 6.35097 5.62176 7.42053 0.356932 11.8509 -433 1 7.85865 2.26615 9.45505 -4.28533 -3.16859 -37.0089 -434 2 7.29966 2.29372 10.2234 -12.0252 -4.85104 14.2867 -435 2 7.31757 1.89726 8.71059 11.6806 10.5906 18.7024 -436 1 15.1499 14.8389 13.7285 -7.78284 7.72319 0.275575 -437 2 14.8617 14.9509 14.6481 -0.524909 3.36892 -5.65775 -438 2 14.6832 15.507 13.1912 6.48748 -10.1003 7.43034 -439 1 9.39784 8.36731 3.82962 2.5344 -9.0015 0.237957 -440 2 10.2136 8.88179 3.87227 -2.41531 -0.25237 0.330419 -441 2 9.66909 7.4454 3.98022 -9.00345 8.8328 -4.59515 -442 1 17.7291 13.5977 16.4646 5.88425 13.7422 -6.32319 -443 2 16.779 13.4368 16.4502 -3.47507 3.66531 -1.64514 -444 2 17.9175 14.4327 15.9665 -10.227 -20.4783 11.0606 -445 1 4.89529 10.4518 2.85531 35.8078 -15.8912 -9.72696 -446 2 5.76001 10.066 3.12945 -20.0856 5.21459 -7.60385 -447 2 4.65599 10.9551 3.62329 -7.19184 9.4675 7.77805 -448 1 3.68184 8.40606 9.96257 -7.06038 -13.6752 25.4145 -449 2 3.73025 9.3314 9.75201 2.05841 13.8137 -4.67922 -450 2 3.5201 8.39907 10.9276 1.35511 -1.83367 -14.7667 -451 1 15.9506 6.91676 5.90036 8.23349 -12.8437 -5.59708 -452 2 16.7283 7.39089 6.23923 -5.44721 -6.23743 -4.31526 -453 2 16.2459 6.04307 5.54881 -4.37327 20.9496 12.2757 -454 1 15.2047 7.21919 9.02648 -8.23364 16.7266 -25.0777 -455 2 16.0013 7.62239 9.37026 6.97324 -0.496136 10.989 -456 2 14.9764 7.76869 8.23928 2.79192 -13.8116 16.1423 -457 1 6.18989 12.8346 12.7303 -2.33267 17.6694 7.57139 -458 2 6.82101 12.228 13.1265 8.54383 1.14333 3.13472 -459 2 6.09938 13.6243 13.3122 2.17121 -15.6415 -7.8487 -460 1 12.1177 4.51675 13.1173 40.066 24.623 8.84127 -461 2 12.3608 4.67527 14.0558 -10.9347 -6.25445 -11.8552 -462 2 11.2865 4.0907 13.0625 -30.7168 -15.659 3.72413 -463 1 11.4382 8.09379 7.90765 11.4031 -1.65515 0.349674 -464 2 12.1555 7.64923 7.40412 -12.1024 3.57709 12.4555 -465 2 11.7306 8.14579 8.84607 -3.22191 -0.660368 -24.1915 -466 1 17.0422 10.838 7.59458 18.8696 -14.9771 -17.3127 -467 2 17.8015 10.2845 7.30277 -16.9558 5.34042 10.7777 -468 2 16.8989 11.446 6.8574 -4.66599 0.747798 1.74373 -469 1 5.2881 18.0926 10.8094 -12.0199 -6.67836 -5.57022 -470 2 4.87565 17.5902 11.533 4.52174 5.42574 -9.9319 -471 2 4.66447 18.0398 10.0548 7.40461 3.40643 11.786 -472 1 7.61349 17.4864 1.6652 -5.64906 3.24499 15.5952 -473 2 7.84327 16.7088 1.17852 12.3306 -20.6776 -4.28559 -474 2 7.74119 18.1865 1.04014 -3.89506 18.5858 -12.7246 -475 1 1.91944 12.8991 13.6003 2.94725 10.7513 13.4495 -476 2 1.49936 12.2949 14.2301 -1.35275 4.24281 -4.32331 -477 2 2.12078 13.7179 14.107 -1.08361 -15.4355 -11.6139 -478 1 9.36899 6.74386 14.7638 -2.26814 18.4847 -3.39127 -479 2 9.81478 6.02606 15.213 8.95117 -11.473 0.808352 -480 2 9.85086 6.98618 13.9577 -2.76657 -9.1339 3.81591 -481 1 15.2853 4.27459 10.7783 -6.29839 -2.79317 -1.65183 -482 2 16.2088 4.11106 10.5808 3.62417 -3.44414 3.50356 -483 2 15.3067 4.91761 11.4912 -1.69264 4.92972 1.1484 -484 1 11.3393 6.23844 0.0959214 -19.2017 -19.0623 -2.27733 -485 2 11.4465 5.27934 18.8311 9.36926 7.99257 -4.22996 -486 2 10.3892 6.29463 18.5179 14.2332 9.643 5.73673 -487 1 18.5128 11.4549 14.9487 -3.47415 -8.47336 -12.1105 -488 2 18.0135 11.8846 14.234 9.23154 -3.06455 1.62932 -489 2 18.3213 12.0172 15.6945 1.79799 8.69016 10.3557 -490 1 7.01602 9.27569 7.3226 -14.4634 -16.8581 15.1781 -491 2 6.67273 8.48369 7.80259 5.98597 16.4947 -15.5019 -492 2 7.96023 9.16216 7.29002 13.6661 -3.40194 -2.89589 -493 1 18.3593 15.3216 12.2421 14.2565 8.37053 -9.09139 -494 2 0.609114 15.6531 12.0121 -9.26774 -5.34503 6.02371 -495 2 17.7657 15.7501 11.6106 -0.96984 1.15192 3.02291 -496 1 16.5123 4.36636 5.2899 -20.1169 0.0802899 32.1896 -497 2 16.6197 4.39367 6.27015 0.689823 -6.50354 -17.1519 -498 2 17.3637 4.55338 4.93619 30.7718 -0.208347 -14.1282 -499 1 17.7452 3.18489 10.789 3.81546 21.3325 5.47337 -500 2 18.6747 3.34524 11.0396 -11.7638 -6.52287 -4.76545 -501 2 17.6832 2.38146 10.2881 5.2294 -17.628 -7.02183 -502 1 12.3161 18.6216 10.0891 7.2643 12.1904 3.38538 -503 2 11.4836 0.405415 10.3905 15.4316 -4.87983 -6.88019 -504 2 13.0526 0.636416 10.1289 -21.6037 -8.70048 2.57237 -505 1 10.3866 9.75789 12.4872 13.2725 15.9888 14.5072 -506 2 11.1625 9.86545 13.086 -15.7493 -4.39745 -10.7974 -507 2 10.2528 8.81785 12.4 2.63286 -10.7197 -2.15993 -508 1 0.710964 2.68685 7.1375 -0.1398 22.218 7.12103 -509 2 0.988905 3.47272 7.66294 -4.49485 -18.6961 -10.7978 -510 2 0.93208 1.94131 7.68754 4.63119 -8.38422 8.20051 -511 1 0.281684 15.3172 6.85959 12.828 -38.7344 -20.2135 -512 2 0.500898 15.7193 7.67574 7.5107 6.97721 30.9172 -513 2 0.662709 14.3998 6.92418 -16.2289 29.7866 -9.89698 -514 1 17.0547 6.94606 15.0133 0.165691 -3.90506 -0.393601 -515 2 17.812 7.5465 14.9118 -2.55694 -6.08978 1.76467 -516 2 17.3809 6.10212 15.3719 1.63232 8.8395 -1.4121 -517 1 9.12112 12.493 8.02809 -41.9273 18.4298 17.1595 -518 2 9.51251 11.917 7.38329 0.012751 -17.4797 -14.5944 -519 2 8.13115 12.5622 7.88239 38.3085 -7.50107 -2.24579 -520 1 1.15265 1.71178 2.84381 -8.4531 -11.9611 -9.59212 -521 2 1.05399 2.26522 2.05124 -0.803687 -1.8039 9.5303 -522 2 1.83355 2.04817 3.41993 6.13064 16.5152 3.77918 -523 1 4.1533 15.0772 10.0179 -3.20174 -0.437736 -9.29092 -524 2 3.98656 15.1016 9.06421 1.0299 1.2944 4.52592 -525 2 5.05261 14.7702 10.1253 7.00528 -3.42074 -2.93025 -526 1 7.40026 2.22746 14.7687 6.49168 5.19513 -3.0061 -527 2 7.05161 1.63346 14.1063 -3.12724 -4.90201 -3.09738 -528 2 7.91685 2.87588 14.258 -12.5256 -3.95349 11.2802 -529 1 18.373 14.546 2.1576 32.8202 -8.56769 3.71586 -530 2 0.641523 14.7991 2.40659 -13.3331 -4.12423 -2.43111 -531 2 17.8688 15.3457 2.17573 -14.9783 16.0191 -2.18472 -532 1 10.0269 2.72027 12.9069 6.62939 -13.0178 -15.3878 -533 2 10.0552 2.15154 12.1041 -3.85604 9.52515 15.5624 -534 2 9.22213 3.24102 12.837 -1.7712 4.41938 -1.42751 -535 1 2.97754 8.87028 12.9985 -9.05038 -0.677068 -3.47801 -536 2 3.45417 9.69118 12.8049 -4.31376 -0.734034 1.18179 -537 2 3.62806 8.2766 13.3769 7.01874 -2.97808 -1.19575 -538 1 3.19567 8.6035 3.77658 -19.8399 -15.185 62.8422 -539 2 3.69787 9.2024 3.27039 20.7823 26.7884 -21.1607 -540 2 3.25417 8.93577 4.73429 1.71088 -18.6185 -45.3432 -541 1 5.68333 7.2353 8.59567 4.24349 7.94903 8.11652 -542 2 5.64033 6.27333 8.54735 -2.49289 0.630165 -0.0839225 -543 2 5.00997 7.53803 9.22801 3.10928 -6.89318 -6.51723 -544 1 14.901 1.57394 1.8387 15.5968 1.99798 -17.643 -545 2 15.036 2.2757 2.46438 -7.07983 8.8607 13.8203 -546 2 15.4483 1.85956 1.08282 -11.9705 -11.4344 6.74504 -547 1 8.60581 15.0641 0.724175 -1.0343 -0.581701 -1.65436 -548 2 9.36267 14.9264 1.3224 -11.0408 7.07619 -5.07103 -549 2 7.85377 14.5885 1.11097 4.42293 -0.805501 -0.698164 -550 1 15.4669 1.42093 7.20398 -6.02567 -16.758 -12.9624 -551 2 14.8047 0.91537 6.67859 11.4397 13.2212 12.6179 -552 2 15.1632 2.33261 7.23494 -7.42764 0.585266 4.6538 -553 1 4.96609 12.9239 18.4605 4.9692 1.49742 18.5571 -554 2 5.35493 12.9668 0.719228 -7.36506 -0.705061 -15.6984 -555 2 5.64055 13.3191 17.899 -0.422768 -0.432726 -0.922633 -556 1 15.3869 8.64959 18.0541 15.2167 5.00615 -15.1922 -557 2 15.9585 9.21901 17.4831 -18.3202 -12.4364 12.18 -558 2 15.1184 9.19177 0.153179 1.36579 6.92031 5.44875 -559 1 12.0051 3.11685 18.332 2.92261 2.37371 -0.430118 -560 2 12.2267 2.91556 0.611981 0.907964 -7.8545 -12.3252 -561 2 12.4512 2.48545 17.7302 -5.34745 5.71129 14.8863 -562 1 13.1901 12.7142 5.17454 1.37013 -5.58194 -4.10925 -563 2 13.4698 11.8626 4.7966 3.05379 7.74077 7.48289 -564 2 13.3871 12.6804 6.11832 -0.290674 -0.040691 0.190289 -565 1 6.14326 7.19304 0.194857 -1.9202 -41.4233 1.79985 -566 2 6.22321 8.10871 19.0299 -3.97355 27.3971 1.06104 -567 2 5.34431 6.86352 0.645447 4.46952 5.26437 -3.48858 -568 1 17.7307 15.8888 14.9367 -21.823 -0.594011 -1.7362 -569 2 16.7484 15.9241 14.9389 21.2696 3.13718 0.352088 -570 2 17.9521 15.7271 14.013 1.78287 0.501162 -2.11552 -571 1 13.1218 0.925759 16.6825 5.50042 -3.78674 2.95198 -572 2 14.072 0.793445 16.8378 -4.97223 1.91263 -2.37602 -573 2 12.7827 0.0340456 16.5234 -2.01103 3.41826 1.69274 -574 1 10.8951 14.5133 7.41586 13.7556 -0.655539 -10.0126 -575 2 10.113 14.0867 7.762 -7.55253 -2.39401 4.078 -576 2 11.587 13.8348 7.46973 -1.14 7.89944 2.21203 -577 1 17.6887 8.43188 2.14728 0.189858 20.0466 16.1607 -578 2 16.8137 8.45099 2.54699 -1.17102 1.13639 1.13697 -579 2 17.5844 7.88298 1.39033 0.906265 -19.3865 -19.2668 -580 1 12.4753 7.78007 2.02858 4.8513 20.3782 0.840615 -581 2 12.1866 8.68618 1.79587 0.511972 -15.0552 5.00442 -582 2 12.026 7.17575 1.43189 -2.95773 1.13832 -8.42618 -583 1 12.0482 14.5597 10.5042 0.0757192 -7.5571 -35.1431 -584 2 12.4064 14.4181 9.58152 -17.4466 3.18024 31.1693 -585 2 11.0871 14.7065 10.4137 10.382 -0.64313 -2.04102 -586 1 6.77399 6.81718 15.4895 -2.25325 13.5751 22.5023 -587 2 7.66157 7.15195 15.2455 -13.2429 -8.30723 6.82645 -588 2 6.46823 7.3192 16.2828 11.602 -10.345 -19.2772 -589 1 7.96932 4.46689 13.3146 44.2968 21.2749 25.8476 -590 2 7.30275 4.56825 12.6635 -24.5307 9.83264 -18.6775 -591 2 8.36434 5.36687 13.4905 -14.8867 -29.3495 -5.61281 -592 1 13.3256 12.2141 14.3822 1.63527 0.767161 7.05401 -593 2 13.3071 11.2456 14.3976 -5.0343 3.13323 -4.4607 -594 2 13.6638 12.4664 13.5147 0.299935 -1.6824 -0.371902 -595 1 14.5332 9.57639 7.29372 1.70864 -17.4355 -8.36329 -596 2 15.3543 10.0193 7.49698 9.6305 7.8311 1.84335 -597 2 13.8455 10.0241 7.76467 -11.6358 9.67674 12.3645 -598 1 12.6873 16.8129 3.32056 7.83014 22.6359 -6.17069 -599 2 12.905 17.3242 4.12577 -3.6908 -4.91509 -14.526 -600 2 12.6713 17.4548 2.56832 -2.22777 -11.4506 21.1383 -601 1 1.00404 7.03926 17.3541 -3.3312 4.1638 -9.33324 -602 2 0.198847 6.6977 17.7452 -7.86562 1.94891 9.68399 -603 2 0.682364 7.69734 16.7196 12.0745 -4.24482 -2.37704 -604 1 12.9524 4.87174 15.7195 8.90342 0.650689 -3.85785 -605 2 13.7851 4.36673 15.5939 -16.3603 12.0475 7.07164 -606 2 13.1756 5.81397 15.8059 7.81047 -7.07308 -0.568692 -607 1 2.31363 3.41121 5.09984 1.34414 -8.27729 12.6429 -608 2 1.77118 2.94066 5.78541 14.4044 18.7697 -14.1923 -609 2 2.78995 4.15649 5.52715 -11.381 -10.4766 -6.15296 -610 1 8.18617 10.9369 13.7076 0.678078 1.53711 40.2692 -611 2 8.26353 10.8511 14.7174 0.0908521 -0.97824 -49.4206 -612 2 8.97116 10.5326 13.3071 -0.268246 2.83437 5.42064 -613 1 12.9797 1.57395 13.2253 -11.1668 13.2146 -3.30054 -614 2 13.4836 1.606 12.3812 -13.0456 2.80048 17.4401 -615 2 12.3844 2.37352 13.292 24.5144 -24.3843 -9.90982 -616 1 6.623 13.6575 2.08401 -19.1133 11.282 9.3836 -617 2 5.9939 13.9784 2.7781 14.9337 -6.87798 -17.2483 -618 2 7.26745 13.1178 2.55198 -2.04458 -0.845032 2.89429 -619 1 15.8406 6.42424 12.5401 -13.2713 -11.8586 11.2716 -620 2 16.4194 6.98592 12.0445 9.49352 10.2235 -13.5209 -621 2 16.1454 6.51524 13.4484 4.14662 -0.822673 1.52229 -622 1 16.7707 0.701968 9.54479 -0.33564 -15.5889 9.3319 -623 2 16.6398 18.4357 9.88026 3.64558 8.61996 -2.27841 -624 2 16.2643 0.755347 8.72872 -0.899564 4.78829 -7.90839 -625 1 6.16924 11.6733 8.25771 14.6298 -10.0406 -3.26225 -626 2 5.33846 11.3866 8.66461 9.26092 -3.17897 1.03444 -627 2 6.69681 10.8652 8.03849 -20.9756 15.4878 5.14008 -628 1 2.79271 8.6573 0.35403 -23.76 -9.02274 -22.2632 -629 2 2.25448 8.23641 18.2541 16.977 17.0562 34.1458 -630 2 2.21462 9.29512 0.821612 5.57875 -9.71134 -10.0126 -631 1 10.106 10.3292 6.60358 -3.61165 1.9136 -10.2284 -632 2 10.6792 9.71276 7.06962 0.244318 -4.43661 2.14915 -633 2 10.3272 10.2595 5.65755 0.987804 2.37269 11.054 -634 1 6.86896 15.7547 6.74185 -9.45188 0.350857 10.5778 -635 2 7.01957 16.2495 7.56813 1.20841 -3.75655 -8.95365 -636 2 6.86937 16.4078 6.03145 5.97827 -1.66506 -1.56051 -637 1 6.52554 12.9289 5.84178 -0.357514 -5.09084 -2.41361 -638 2 6.62829 13.798 6.2286 3.16894 9.75908 1.28602 -639 2 6.09212 12.3914 6.51525 3.69897 1.96572 0.733322 -640 1 16.7568 12.518 9.72465 -9.23185 -13.2632 0.47822 -641 2 16.902 11.7866 9.09243 0.130969 14.0381 8.74694 -642 2 17.3592 13.2171 9.48659 4.61146 3.47499 -3.98224 -643 1 6.24919 2.86496 2.77119 -11.0856 -12.869 -3.38869 -644 2 6.47325 3.75226 2.51474 6.07925 14.4727 -0.649249 -645 2 5.68088 2.55654 2.04869 4.52067 -4.17334 4.94091 -646 1 10.7277 3.04594 3.24275 -5.68944 3.06595 0.875255 -647 2 10.1765 3.79746 3.50451 2.82785 -3.23936 -2.03517 -648 2 10.278 2.63972 2.48897 0.815959 0.513447 0.723514 -ITEM: TIMESTEP -90 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.787 6.66827 17.9842 -16.1402 -3.16192 1.04025 -2 2 7.92621 6.66814 18.4555 15.1954 -0.455805 -12.5376 -3 2 8.71175 6.0436 17.2441 2.25338 3.19171 10.1252 -4 1 0.22099 8.38854 6.75163 1.7867 -5.58088 53.0968 -5 2 0.258391 8.22026 5.83332 5.30707 -13.3892 -38.1472 -6 2 0.61579 7.61263 7.23543 -10.6686 22.8516 -15.6901 -7 1 8.66795 0.370206 6.9239 18.6241 3.37743 -9.56875 -8 2 9.59619 0.315354 6.61478 -16.3273 1.21351 7.23111 -9 2 8.27983 1.03351 6.33448 -2.90229 -5.54848 4.92815 -10 1 6.43573 1.74596 11.7835 34.1799 -16.6044 -13.764 -11 2 5.93979 2.40996 12.1988 -27.1883 29.6469 18.8725 -12 2 5.80753 1.07598 11.5419 -8.40397 -16.9848 -5.34211 -13 1 6.95318 5.50156 2.37044 -56.4905 40.6357 15.9903 -14 2 6.31995 5.85318 3.09808 38.0444 -22.8427 -29.8317 -15 2 6.63738 6.03683 1.59693 20.7004 -19.4106 17.4304 -16 1 16.2563 10.1963 16.0713 -10.5934 -3.27458 3.94447 -17 2 16.9716 10.3961 15.4827 15.3322 4.9096 -4.70747 -18 2 15.8903 11.0434 16.3496 -2.84586 0.096923 -3.72852 -19 1 10.8156 14.9572 2.29652 -13.5477 -14.1276 -10.2117 -20 2 10.6343 14.4303 3.07787 2.79926 -3.05354 4.26547 -21 2 11.1766 15.7627 2.6355 11.3372 16.7492 6.7502 -22 1 17.2002 8.21443 10.9436 15.2126 5.40823 -8.20499 -23 2 16.6458 8.84622 11.4125 -4.33506 2.62691 -0.328418 -24 2 17.9515 8.74734 10.6145 -8.68143 -7.05886 2.54317 -25 1 14.6067 16.0259 16.3377 27.3765 -5.03456 2.51249 -26 2 13.6996 16.2768 16.4047 -22.3019 9.86517 -5.17321 -27 2 14.7963 15.6285 17.196 -1.96556 -8.36093 -2.03831 -28 1 12.1458 13.2907 0.563101 15.519 -14.4585 7.5186 -29 2 11.8598 13.3671 18.2945 -8.9445 7.51312 -6.12139 -30 2 11.6592 13.8773 1.15113 -3.3891 6.78651 -5.827 -31 1 9.32161 5.49231 3.86239 -40.7454 -0.097831 27.7 -32 2 8.82419 5.45502 4.73277 24.2157 -2.28744 -25.4595 -33 2 8.56838 5.45751 3.23664 18.1191 1.43276 -0.568008 -34 1 1.5546 3.92475 11.5547 -2.15894 45.2634 -4.40984 -35 2 1.55046 4.88574 11.8201 -3.55694 -26.3933 -6.97822 -36 2 1.92957 3.45678 12.2837 10.4321 -13.9157 16.7147 -37 1 2.10319 6.96614 8.15085 -9.44208 -8.37285 -17.308 -38 2 2.4095 7.43328 8.92365 8.57391 0.445975 10.2393 -39 2 2.10294 6.01871 8.3456 1.70875 2.69997 7.84786 -40 1 5.23855 4.482 7.82422 -14.5525 -1.69806 -15.7353 -41 2 5.37847 3.52895 7.72628 3.24739 1.15002 6.52498 -42 2 4.55634 4.7134 7.1559 12.5144 1.33119 10.811 -43 1 3.38552 2.88255 17.3879 -7.38377 33.0145 14.859 -44 2 4.08387 3.35622 16.9066 -6.09174 -4.5148 -0.339366 -45 2 2.81217 3.57956 17.8286 22.0641 -22.8641 -14.398 -46 1 7.5324 5.43864 6.19559 -6.90202 6.90038 35.1799 -47 2 8.08818 5.95892 6.84983 -22.5477 -17.4794 -25.4925 -48 2 6.78022 5.04202 6.71812 26.5249 9.35209 -13.645 -49 1 9.82024 7.03039 12.0775 19.8901 0.0780072 21.9724 -50 2 10.117 6.21395 11.6931 4.07542 -9.22938 -4.80372 -51 2 9.09589 7.30435 11.5485 -23.243 9.22364 -20.0663 -52 1 13.9806 3.7694 8.09667 -19.6388 4.31534 -31.7671 -53 2 13.3819 4.49155 7.81719 15.167 -9.87345 1.12215 -54 2 14.3046 4.00637 8.94223 9.52837 8.93591 30.7953 -55 1 4.52742 17.134 3.88467 -0.450754 13.2049 4.39156 -56 2 5.37483 17.5703 4.13521 -18.32 -2.84079 -10.9512 -57 2 3.94957 17.708 3.32475 23.4139 -10.9615 8.41036 -58 1 16.2726 16.5634 10.552 38.1711 -6.17539 -26.5181 -59 2 15.4837 16.6086 11.0514 -31.396 0.528555 16.213 -60 2 16.0986 15.9648 9.80419 -5.24542 6.81385 7.69127 -61 1 1.94125 4.78402 0.0638345 24.0582 25.3647 11.1071 -62 2 2.62474 5.1599 0.67023 -17.1428 -14.5257 -4.57865 -63 2 1.76164 5.54704 18.141 -7.28608 -7.40463 -3.41134 -64 1 11.2518 13.2771 16.4354 2.60185 -12.9515 -12.3757 -65 2 10.6918 12.4717 16.5304 19.7397 14.6013 -5.52798 -66 2 11.8919 13.1107 15.7025 -16.8897 -0.368153 14.685 -67 1 10.0575 10.919 16.7613 6.16873 -18.0385 3.66167 -68 2 10.4442 10.0133 16.8612 -13.1447 30.924 -0.515142 -69 2 9.09987 10.8482 16.7186 0.711039 -4.16381 0.34444 -70 1 11.8614 17.5086 13.5019 6.48767 -7.71286 -13.5562 -71 2 12.4999 17.0938 12.8959 -9.94411 -4.10313 8.27478 -72 2 12.0757 18.4326 13.4127 -0.0140719 16.2542 2.74368 -73 1 6.39981 9.50139 12.337 -4.6648 -8.8035 -19.3883 -74 2 6.97362 9.2422 11.6012 -0.80266 1.15987 5.77958 -75 2 6.9622 9.95325 12.9581 6.38846 6.66359 6.95977 -76 1 16.2975 12.8974 2.78222 -12.345 -27.8929 4.9875 -77 2 17.1496 13.2141 2.51749 15.349 9.48057 -2.38836 -78 2 15.7502 13.672 2.87844 -10.3717 9.81447 0.854078 -79 1 0.774 12.7819 5.86324 -32.223 -2.64552 -12.7856 -80 2 1.10971 12.9185 4.95432 -4.25214 -7.81578 11.8108 -81 2 18.4306 12.6074 5.76822 36.341 8.50215 1.05579 -82 1 5.29891 16.3721 18.4261 6.47 -16.9938 9.7884 -83 2 5.51669 15.4746 18.1046 -4.53971 18.6444 -2.10572 -84 2 5.85038 16.4657 0.570301 -5.83847 6.29943 -2.02707 -85 1 0.695227 7.70772 4.16735 36.5725 18.4792 -22.7587 -86 2 0.10368 7.96447 3.43723 6.76909 -3.37176 10.733 -87 2 1.60166 8.10351 3.91123 -45.3891 -20.8895 14.9183 -88 1 3.19365 9.10151 6.50287 -37.0597 -13.4257 3.63648 -89 2 3.6513 8.68447 7.23829 0.216969 0.250287 -1.31356 -90 2 2.24726 8.75126 6.54108 37.1121 17.8096 0.286984 -91 1 7.35199 10.4473 16.1779 -19.0362 -10.3824 27.97 -92 2 6.56517 10.9544 15.9216 9.49501 -5.7134 5.26362 -93 2 7.13832 10.0279 17.0488 0.309364 15.3336 -19.7914 -94 1 11.0163 0.890853 5.00632 -3.98909 -12.3472 3.8442 -95 2 10.8807 1.76939 4.61668 6.53092 -8.55309 -4.92776 -96 2 10.738 0.225438 4.34173 2.35985 18.608 2.04389 -97 1 4.21667 2.95093 13.149 10.2014 -19.1015 31.4776 -98 2 4.53515 3.41914 13.9504 -8.71013 -4.86526 -13.316 -99 2 4.15898 1.99936 13.4513 -0.534052 25.4454 -15.6313 -100 1 8.50322 10.2612 1.79208 -4.34668 -17.3092 21.2914 -101 2 8.27549 10.8526 2.5321 5.30441 -1.44182 -6.44774 -102 2 8.58493 9.36982 2.21324 2.85947 21.4101 -9.02924 -103 1 10.3161 1.69184 15.4745 -6.1912 0.342966 -7.58309 -104 2 11.1781 1.38278 15.7166 17.9205 -0.758309 5.87707 -105 2 10.347 1.84648 14.5196 -5.50104 2.18071 3.0962 -106 1 2.60936 12.9662 7.92592 -2.1007 2.96569 -8.82009 -107 2 3.10883 13.7131 7.55922 1.74385 -4.33572 0.675454 -108 2 1.96491 12.7329 7.23617 6.25685 -1.04193 4.90183 -109 1 3.83706 11.6816 4.96058 -22.5573 -14.4893 8.95363 -110 2 3.56827 11.1846 5.76493 10.0033 8.11351 -16.9036 -111 2 3.08816 11.5736 4.33469 10.7007 11.5305 11.906 -112 1 6.6582 14.5337 16.9912 3.19916 -10.5164 -7.18554 -113 2 7.36558 15.1576 17.1605 2.12516 -0.469731 1.77687 -114 2 6.47854 14.5937 16.0445 -2.82585 4.49818 1.60201 -115 1 14.2037 14.4903 3.21857 16.956 -7.57282 -16.8086 -116 2 13.9492 15.374 3.44691 -9.21692 15.261 -0.929302 -117 2 13.8764 13.9351 3.91269 -8.69982 -10.6193 13.7942 -118 1 8.69855 18.0357 16.1264 41.5507 -6.08144 10.5978 -119 2 9.33855 17.4056 16.5195 -30.3672 -5.67283 -6.86348 -120 2 9.34419 0.0405339 15.8183 -19.2067 16.0047 -5.03817 -121 1 4.69307 1.79842 4.89677 16.2385 30.5389 -26.6001 -122 2 3.80396 2.19318 4.80489 14.8244 -2.46841 6.40587 -123 2 5.29999 2.32882 4.27745 -28.5893 -25.5208 24.7929 -124 1 15.0277 12.5795 16.5521 32.6678 1.07726 26.51 -125 2 14.723 12.7481 17.4682 -6.07814 3.10734 -21.8061 -126 2 14.3421 12.5499 15.8992 -22.7964 0.862239 -7.92322 -127 1 15.7044 18.5089 16.8468 26.9219 -3.0014 45.6431 -128 2 16.268 18.6119 17.6883 -20.0241 -2.05323 -42.0683 -129 2 15.5234 17.5608 16.7959 -6.5303 3.1055 -1.70461 -130 1 1.37672 1.34924 16.652 -10.0314 2.12664 3.94932 -131 2 2.13238 1.94076 16.8287 -14.5592 -12.7899 -0.0819953 -132 2 0.657997 1.59844 17.2733 17.8805 -0.89879 -9.33461 -133 1 18.2331 4.34642 15.9005 -0.884234 -3.04582 -21.1642 -134 2 17.8346 3.73179 15.2509 9.01129 10.3034 11.7071 -135 2 0.449037 4.61451 15.5361 -9.49368 -5.77709 6.1071 -136 1 12.1007 17.0847 16.1341 -21.8736 -13.8645 50.4236 -137 2 11.3773 16.6353 16.6829 29.7152 15.2039 -30.2146 -138 2 11.8045 17.1565 15.2358 -4.92233 -3.24187 -16.5992 -139 1 16.1203 2.66556 18.245 -33.6191 11.8512 -24.8852 -140 2 15.5683 3.39571 18.6154 19.5646 -10.4389 -9.45588 -141 2 15.8602 2.60471 17.2935 4.4965 0.524143 22.3318 -142 1 6.68711 13.7575 10.0686 6.57394 0.780895 15.4701 -143 2 6.65896 13.3749 10.963 -3.37269 2.77311 -6.77332 -144 2 6.71723 13.0193 9.46247 -3.0919 -8.05072 -6.49535 -145 1 10.1832 18.4638 2.68288 15.4984 11.1175 -14.1442 -146 2 10.4797 0.410785 1.94548 -7.56539 -13.8801 19.3089 -147 2 9.29042 18.2071 2.48382 -12.5464 -2.66261 -5.58966 -148 1 3.06565 17.654 6.19973 -11.4817 2.82915 -15.5316 -149 2 2.17867 17.6912 5.79869 7.15707 -3.68965 15.0105 -150 2 3.60434 17.7569 5.40979 11.429 -4.57556 5.13078 -151 1 12.6359 16.7831 7.87678 -34.4323 5.42099 5.88286 -152 2 11.8215 16.2589 7.70694 19.4452 0.972157 -0.554869 -153 2 12.3283 17.4377 8.53506 12.9634 -4.48143 -6.06952 -154 1 14.8812 15.2555 8.26349 -9.13488 6.23831 13.721 -155 2 14.2179 15.9485 8.09528 6.25869 -7.42326 0.874894 -156 2 15.4123 15.1764 7.46942 0.572987 8.13089 -2.89012 -157 1 17.8363 18.2748 0.235726 -36.9104 2.14965 -2.72595 -158 2 18.5544 17.6878 0.132306 25.4932 -25.6882 -8.95291 -159 2 18.2375 0.371142 0.648791 5.78715 27.9621 12.2792 -160 1 0.76648 10.5228 1.42349 -23.6052 -44.6853 36.9297 -161 2 -0.0625164 10.0248 1.72181 36.7073 15.4552 -13.6362 -162 2 0.483164 11.1861 0.82966 -10.4498 25.872 -24.2739 -163 1 1.81496 12.3027 3.28068 4.06427 7.40541 18.1542 -164 2 1.38036 11.6556 2.74613 -8.62838 -16.0879 -14.4133 -165 2 2.12935 12.9782 2.6808 0.203437 6.54347 -1.70293 -166 1 0.715096 17.2857 4.99328 6.02973 16.9927 -22.851 -167 2 -0.0549074 17.8034 5.17132 -8.63108 24.1627 -3.07112 -168 2 0.561936 16.5317 5.51148 1.70853 -39.3498 23.4345 -169 1 1.0126 0.815092 9.34853 9.77893 1.05612 10.9097 -170 2 1.24172 0.537916 10.2451 4.93082 3.28815 4.21298 -171 2 0.133534 0.483606 9.24599 -18.3012 -2.93221 -7.23643 -172 1 16.7899 2.36695 13.4143 1.34336 11.0529 -24.546 -173 2 16.9036 2.71504 12.491 -0.235106 -7.90147 26.8103 -174 2 16.4417 1.47344 13.309 3.25474 -1.82726 5.59598 -175 1 2.66167 16.0077 12.0598 12.6303 -22.6944 6.71055 -176 2 3.01062 15.6298 12.8947 -8.01809 9.38789 -15.4913 -177 2 3.11281 15.5097 11.3415 -7.7677 12.8204 10.8964 -178 1 16.364 15.512 6.14932 19.0855 9.58845 -19.9598 -179 2 17.3177 15.4404 6.40388 -23.0707 9.20906 -7.80583 -180 2 16.2465 16.2844 5.52559 8.28806 -24.9431 19.8586 -181 1 5.77951 5.20043 11.8033 8.47507 -20.9263 -15.707 -182 2 5.6405 6.00993 12.2754 -6.27864 14.793 10.9641 -183 2 5.18835 4.5564 12.2066 -2.11002 -1.11499 -2.91817 -184 1 15.1794 4.92089 0.775894 -18.0102 -8.76269 31.4284 -185 2 14.9497 4.67568 1.72392 8.26683 8.97624 -32.6089 -186 2 14.3636 5.23769 0.366515 4.70525 -0.664057 3.69432 -187 1 16.3975 16.4382 1.83859 15.8969 -1.83249 -31.9545 -188 2 16.3175 16.7184 2.73629 -8.02889 11.6848 21.5541 -189 2 16.8259 17.1655 1.34034 -8.03244 -7.80667 10.4102 -190 1 0.153841 4.83744 3.963 18.3567 41.8245 -8.83163 -191 2 0.481764 5.78512 3.86014 -17.0028 -34.1388 7.97498 -192 2 0.952119 4.32423 4.11352 -0.77715 -2.59924 4.82879 -193 1 2.94647 15.0748 15.1079 -17.5423 -9.74792 39.2804 -194 2 2.84668 14.6538 16.0052 7.88621 4.55617 -28.9019 -195 2 2.37581 15.8415 15.2342 5.36547 9.02165 -11.4736 -196 1 1.04118 14.6398 9.41517 21.0794 -20.4815 -17.0137 -197 2 1.63478 13.9208 9.06194 -19.3512 25.5288 8.96267 -198 2 0.7851 14.3144 10.2695 -7.28135 -4.68142 11.1743 -199 1 13.5343 16.512 11.5541 0.415781 17.9887 -13.1724 -200 2 13.2087 17.3014 11.0493 5.42519 -19.6136 10.4452 -201 2 13.1525 15.7431 11.1062 -5.37134 4.1326 5.42785 -202 1 4.79073 1.57335 0.678685 -10.2425 -16.6589 -0.602312 -203 2 4.2243 2.02466 0.0269211 5.06007 -3.50169 9.95598 -204 2 4.26355 0.829094 1.04695 5.40097 16.8315 -2.73739 -205 1 1.55169 18.6011 11.9401 -14.2618 14.3088 -13.4455 -206 2 1.54559 0.423493 12.7773 -0.760074 5.21042 2.72529 -207 2 2.10509 17.8447 12.0596 11.7149 -17.0814 4.30068 -208 1 11.3926 10.0859 4.15406 35.1149 20.4659 -18.5884 -209 2 11.4922 10.6036 3.30306 -8.07316 -21.3073 26.3838 -210 2 12.3257 9.94393 4.45754 -25.8381 1.71308 -8.95455 -211 1 8.18732 12.2257 3.75704 -12.727 -0.351394 27.2441 -212 2 9.08394 12.5468 4.00553 -19.5779 -3.96369 2.83586 -213 2 7.55786 12.2705 4.55735 35.1927 2.13842 -31.3906 -214 1 14.6183 4.0143 3.36201 13.432 11.2186 16.7224 -215 2 15.2472 4.27703 4.07585 -12.4329 -9.47893 -15.9273 -216 2 13.7521 4.30159 3.67007 -0.91716 0.860244 -2.07153 -217 1 5.73358 1.67843 7.60794 -24.3615 -22.8066 38.6551 -218 2 5.03202 1.06037 7.9982 26.7251 29.011 -15.8684 -219 2 5.4689 1.83957 6.71483 -6.40801 -4.86943 -26.9957 -220 1 17.8709 0.966847 4.84319 9.19834 18.9135 -13.8104 -221 2 18.365 1.30942 4.06688 -7.16187 -11.4028 13.2983 -222 2 17.8528 1.72071 5.45189 -4.56365 -9.98849 0.137087 -223 1 6.8232 9.21412 4.53503 0.0591715 -6.07859 -16.7729 -224 2 6.61803 9.33533 5.45725 2.71524 4.28405 13.1117 -225 2 7.76963 9.02928 4.48077 0.0640272 -1.66157 1.55662 -226 1 2.43776 14.707 2.05519 12.3789 -12.7502 -17.0618 -227 2 3.26162 14.6424 2.56361 -5.44595 2.48516 -0.426941 -228 2 2.66563 14.4192 1.14611 -3.66427 9.22898 15.3942 -229 1 17.2291 12.9271 13.0675 -25.7945 34.5425 2.40746 -230 2 16.3582 13.328 13.3279 21.6203 -16.0155 -5.62376 -231 2 17.7378 13.7209 12.8173 -0.837652 -12.191 -0.563337 -232 1 14.8245 10.5613 1.47762 -19.5687 -28.1113 -12.7998 -233 2 15.3117 11.2776 1.82539 19.2978 30.1093 14.6064 -234 2 13.9052 10.723 1.70642 0.475408 2.13461 -1.67485 -235 1 5.64982 6.63563 4.55084 7.38671 -15.2963 15.0755 -236 2 5.89214 7.54949 4.44479 2.16454 16.7651 -4.4857 -237 2 6.3044 6.30345 5.19757 -6.24708 1.07556 -9.93912 -238 1 8.10845 8.3271 10.3627 -2.57156 5.78827 13.3728 -239 2 8.61892 8.85799 9.7482 5.06505 3.86155 0.738683 -240 2 7.30116 8.09886 9.91192 -6.7312 -10.1116 -10.9746 -241 1 13.4488 18.4608 5.65963 -13.3307 -19.6223 8.99938 -242 2 12.6096 0.239632 5.39678 7.81848 3.10411 6.37483 -243 2 13.1935 17.7385 6.2846 5.11891 19.4349 -8.45882 -244 1 -0.00278136 2.5625 0.408955 -12.183 35.1922 -19.112 -245 2 17.7147 2.60224 18.7259 18.9642 -9.11891 12.7486 -246 2 0.290302 3.48872 0.227759 6.22068 -26.2608 7.60118 -247 1 12.9842 10.8497 9.70117 -72.6257 27.1129 -13.2266 -248 2 11.97 10.965 9.69449 48.4921 6.31007 0.109369 -249 2 13.0048 9.91956 9.83068 16.3628 -25.292 6.36111 -250 1 0.548273 12.2593 11.2103 29.2233 3.63314 -8.31727 -251 2 18.2651 12.1894 11.4198 -11.8267 3.42799 7.99272 -252 2 1.06577 12.5175 11.9926 -12.6507 -2.71608 -2.06856 -253 1 5.24515 7.35168 13.3154 -11.9716 -5.94003 -7.6844 -254 2 5.73604 8.07931 12.9223 2.64227 5.43904 4.60776 -255 2 5.63818 7.16239 14.1672 7.7875 0.124539 4.29694 -256 1 1.16856 6.76355 12.0035 -37.5881 -40.6251 -19.8542 -257 2 0.334741 7.08942 11.6206 8.86965 -4.87383 5.4559 -258 2 1.63397 7.52151 12.2381 28.649 45.7996 14.9133 -259 1 15.5501 9.75639 12.3967 -1.92883 21.1886 15.8166 -260 2 15.1116 10.6344 12.221 21.3449 -31.3991 6.12972 -261 2 16.0605 9.85526 13.2245 -13.7753 0.465455 -14.4819 -262 1 16.5858 12.6354 5.59083 -2.62715 14.8355 -19.0185 -263 2 16.4437 13.5882 5.83081 0.436603 -22.1434 -16.2318 -264 2 16.416 12.5171 4.60718 5.48378 12.0784 33.3147 -265 1 6.40279 9.86277 0.0794915 -20.3924 -8.41649 -9.56759 -266 2 5.55524 10.218 0.380594 4.23452 2.32222 -1.66862 -267 2 7.0555 10.2042 0.674211 16.128 4.48978 14.4774 -268 1 12.2427 6.01171 4.00399 -23.1281 -36.6346 24.2315 -269 2 12.2798 6.64894 3.31747 0.117026 23.2517 -16.0656 -270 2 11.2984 5.74139 4.08171 19.6095 7.84283 -4.73597 -271 1 0.360057 12.9056 0.031807 -8.11921 2.1908 5.08387 -272 2 18.8977 13.4796 0.805411 -3.72305 -1.59029 -3.55744 -273 2 18.3786 13.2516 18.0169 7.85083 -4.92073 3.80969 -274 1 3.55677 18.7152 8.66247 19.9063 -6.335 -5.44295 -275 2 3.49677 18.1902 7.8473 -5.97778 6.84736 4.02201 -276 2 2.66917 0.348355 8.87781 -8.06089 0.921211 -3.36616 -277 1 7.26214 17.4262 4.43744 19.2672 26.0801 -3.30237 -278 2 7.75433 18.2474 4.74147 -22.4281 -27.0983 -14.818 -279 2 7.37471 17.3728 3.46226 -1.25032 2.03681 18.5343 -280 1 9.25258 17.1703 12.1759 28.8617 -14.1678 9.07352 -281 2 9.26958 16.3393 11.6513 -2.57153 16.4076 7.11435 -282 2 10.1283 17.1978 12.6604 -29.6357 0.448077 -14.593 -283 1 13.2677 13.193 7.99719 -21.1722 -32.5843 10.0566 -284 2 13.3388 12.6042 8.77917 0.104276 5.764 -17.169 -285 2 13.8077 13.9427 8.17139 23.4211 18.1414 5.93605 -286 1 14.7593 2.91325 15.4943 24.3728 -2.49696 -23.5999 -287 2 14.0361 2.3713 15.1546 2.238 -3.60609 4.01929 -288 2 15.4274 2.94021 14.7667 -15.6113 -2.56038 15.0831 -289 1 9.9738 15.6484 16.9671 -8.54083 0.59912 -5.05632 -290 2 10.1057 14.7848 16.5569 10.1368 1.85589 1.18764 -291 2 9.46144 15.457 17.7506 -1.80616 -1.66933 10.9911 -292 1 11.2344 8.55758 16.6355 7.77426 1.92795 -6.45244 -293 2 10.4646 8.11257 16.295 -8.96701 -9.58703 -5.10609 -294 2 11.6991 7.91388 17.1598 3.61158 -8.68538 8.99751 -295 1 4.14955 18.3179 16.8036 -6.71252 9.00681 -6.36217 -296 2 4.47312 17.6803 17.4466 6.33314 0.74429 2.85153 -297 2 4.24503 0.569095 17.1648 -0.42517 -11.8307 0.148866 -298 1 2.33957 4.29184 8.91302 22.2448 -7.34702 27.8454 -299 2 3.30686 4.08394 8.81247 -29.123 7.66299 4.05924 -300 2 2.12598 4.16624 9.8839 8.54186 0.354435 -34.7065 -301 1 9.95255 10.4179 9.8571 -18.8164 27.0404 -12.2944 -302 2 9.4534 11.1894 9.4744 17.3372 -21.5482 9.10503 -303 2 9.8309 10.4683 10.8129 6.92766 -2.76642 -0.156957 -304 1 9.80127 0.922938 10.8108 4.3272 3.59983 6.04006 -305 2 9.35046 0.175669 11.2139 0.840012 -6.18623 1.13214 -306 2 9.1369 1.38463 10.2905 0.460774 -0.831922 -5.90435 -307 1 9.16459 15.1765 10.2101 -26.8722 -7.06493 -21.2153 -308 2 8.97785 15.8968 9.57551 3.0406 -6.31351 13.2231 -309 2 8.39419 14.5643 10.0571 23.5779 16.7742 11.4525 -310 1 0.773683 9.7544 10.1833 18.261 11.1305 -23.2394 -311 2 0.868202 10.7262 10.3345 -3.82315 -24.612 -0.100636 -312 2 1.30536 9.53677 9.37727 -17.4146 8.84667 24.1623 -313 1 17.2096 4.87642 8.04469 -12.9959 -9.21067 35.1395 -314 2 16.3347 5.16277 8.3943 19.7751 -0.094318 -9.55648 -315 2 17.6197 4.3572 8.78272 -10.3132 11.9302 -24.4143 -316 1 14.8095 14.6496 0.0373288 -5.69372 -9.04424 21.9283 -317 2 15.5101 14.9524 0.640087 -10.906 0.748239 -2.66247 -318 2 14.0769 14.3265 0.613297 14.425 8.36295 -12.6903 -319 1 3.89537 11.0996 9.55593 -9.82967 16.3938 -0.398364 -320 2 3.93242 11.2996 10.5001 -1.21387 -1.78602 1.5381 -321 2 3.39392 11.8407 9.15947 5.2768 -13.1919 0.569667 -322 1 11.4169 10.7371 1.49225 5.47317 24.4145 -6.81884 -323 2 11.5532 11.6314 1.08329 0.074839 -23.6179 10.2373 -324 2 10.4618 10.6109 1.50924 -1.9569 -1.96948 -2.8184 -325 1 13.1395 7.21524 12.5729 -20.455 -7.16835 0.858137 -326 2 14.0577 7.03675 12.4308 23.1896 -1.74136 0.0778831 -327 2 12.7378 6.3322 12.608 -1.47964 6.92135 2.9072 -328 1 9.65614 1.96645 0.86496 18.1931 4.09637 20.8777 -329 2 8.84682 1.67677 0.484793 -23.8326 -3.90796 -8.97572 -330 2 10.1746 2.31935 0.150168 8.91513 5.01659 -9.40528 -331 1 10.6386 13.4197 4.53193 2.28663 -4.65747 18.8344 -332 2 11.4948 12.9639 4.69275 -16.1918 12.7288 -0.469196 -333 2 10.3958 13.8423 5.38242 9.30576 -5.17735 -13.1714 -334 1 14.5273 1.57884 10.9459 15.1221 22.4117 -0.776229 -335 2 15.362 1.31139 10.5257 -10.7732 -5.17355 3.70166 -336 2 14.6474 2.54531 11.0746 -6.11584 -12.5888 -6.32845 -337 1 14.4766 12.0159 11.6273 -10.9263 4.56586 -44.1867 -338 2 15.2047 12.4077 11.0864 -12.0042 -9.95663 15.0185 -339 2 13.8634 11.5981 10.9451 22.3117 17.3775 30.6101 -340 1 8.16847 5.14124 9.81669 -29.5484 17.7318 23.7918 -341 2 7.27475 5.12719 10.2684 30.6512 -1.40914 -16.6308 -342 2 8.33799 4.26267 9.50012 -3.06916 -18.2431 -3.24008 -343 1 1.5108 16.9662 18.5044 9.55151 26.7901 -23.2493 -344 2 1.84435 17.2897 17.6363 -7.76754 -5.77411 19.656 -345 2 1.83481 16.0826 18.5596 5.96378 -22.3257 1.76596 -346 1 1.42717 17.3886 15.3379 47.0554 -13.0927 -7.45492 -347 2 1.50543 18.1882 15.8264 3.14075 27.3625 12.617 -348 2 0.523906 17.2066 15.2924 -49.7083 -12.5335 -2.74225 -349 1 3.49173 5.73723 6.04987 -5.63889 12.5308 6.32322 -350 2 3.05134 6.46754 6.5425 11.5005 -15.9447 -9.63575 -351 2 4.14223 6.14285 5.45548 -4.8412 1.1033 3.2125 -352 1 12.5916 9.51872 14.2408 10.4293 -27.0271 -12.8548 -353 2 13.028 8.79356 13.6831 -19.628 26.0366 30.4849 -354 2 12.3513 9.14884 15.1174 6.55215 0.813797 -17.5332 -355 1 4.09544 15.2089 7.12218 31.8609 13.6269 2.32941 -356 2 3.67616 16.0257 6.80924 -1.84113 -5.17266 1.34804 -357 2 5.07546 15.4284 7.13078 -32.8392 -10.6488 -3.17146 -358 1 0.799143 8.79431 15.1488 8.21516 12.8732 -16.9375 -359 2 0.575284 9.7423 15.0796 -2.5473 -12.0602 5.3867 -360 2 1.52676 8.70151 14.5038 -8.32138 -2.51513 8.31525 -361 1 12.8725 8.28632 10.0993 13.5644 -10.3417 -12.785 -362 2 13.6812 7.81606 9.78663 -13.8637 7.80766 13.5238 -363 2 12.7502 8.10095 11.0322 6.24745 -8.27276 5.3213 -364 1 15.2423 7.98405 3.44353 15.6799 19.5655 -11.9659 -365 2 14.4463 7.83544 2.89643 5.54982 -16.2362 17.4101 -366 2 15.5184 7.39607 4.17406 -22.72 2.15229 -11.0841 -367 1 17.1687 6.76019 0.0376092 -10.314 6.5713 -12.413 -368 2 16.7239 5.93548 0.292072 -0.0664332 9.88195 -1.29815 -369 2 16.4741 7.34647 18.2846 16.8516 -16.4801 16.1304 -370 1 8.96925 6.98328 7.86383 -27.8745 -15.8066 22.0328 -371 2 9.86939 7.24269 7.81058 30.3142 9.1639 -3.03437 -372 2 8.87474 6.48936 8.713 -1.39219 10.6855 -19.1169 -373 1 12.482 0.614891 1.23015 1.92335 -8.70167 1.10105 -374 2 13.2432 1.03802 1.64803 2.06157 -2.24376 -3.30204 -375 2 12.803 0.16068 0.442821 -0.913907 6.47573 3.0001 -376 1 5.66871 15.0647 14.4598 7.14191 19.2454 -5.51099 -377 2 4.75956 15.0903 14.7907 1.11348 4.01334 -3.77227 -378 2 5.94804 16.0038 14.294 -6.0872 -24.4911 3.70117 -379 1 3.73529 6.48244 1.70347 -4.32476 7.10488 -19.4811 -380 2 3.3805 7.26573 1.22404 3.0021 -10.505 14.7125 -381 2 3.73285 6.71028 2.6365 -0.71904 4.06656 1.73817 -382 1 3.86925 11.322 12.3296 2.55777 5.65869 0.326193 -383 2 4.7048 11.7602 12.5386 0.0734552 -4.93202 -1.70743 -384 2 3.20028 11.8652 12.7549 -2.96009 3.18005 0.676376 -385 1 5.3196 3.88545 15.7107 -12.565 72.4648 14.1271 -386 2 6.00107 3.31 15.4478 35.5939 -28.3589 -8.92722 -387 2 5.74724 4.80358 15.8116 -17.6513 -43.1362 -7.7855 -388 1 14.0258 10.1309 4.70784 36.378 -19.982 -23.5474 -389 2 14.2654 9.87929 5.60631 -3.02994 -1.07275 0.485782 -390 2 14.6765 9.60938 4.12831 -34.5421 20.7478 23.7761 -391 1 7.50853 17.298 8.98976 4.28677 22.6193 13.4416 -392 2 7.01472 17.6504 9.76182 0.935323 -12.9311 -15.6818 -393 2 7.87431 18.0869 8.55212 -1.49272 -9.54271 -2.09709 -394 1 4.57424 14.4015 3.77738 -1.32578 6.84514 50.6918 -395 2 4.51443 15.3073 4.2079 4.46262 -31.6709 -20.6737 -396 2 4.58351 13.7394 4.53798 -1.39317 23.0513 -31.5206 -397 1 14.2431 7.32994 15.8885 26.8814 9.55229 5.02737 -398 2 15.048 7.31796 15.3145 -19.1816 0.583054 17.9404 -399 2 14.5184 7.8184 16.7026 -8.00009 -12.2304 -19.9762 -400 1 3.00564 18.4171 1.98737 1.19435 35.3283 33.2576 -401 2 2.60973 17.9491 1.28647 -18.7059 -24.7202 -27.1582 -402 2 2.28625 0.311703 2.39571 15.2164 -11.2621 -13.5372 -403 1 7.97098 1.60459 4.54116 29.2267 3.13781 -13.0843 -404 2 7.39603 1.96083 3.86318 -8.15365 2.40339 -0.697123 -405 2 8.86388 1.74438 4.1564 -17.9094 -5.03071 12.9608 -406 1 2.50155 14.1648 17.7228 -14.4362 -20.2086 14.4505 -407 2 1.80023 13.5192 18.0233 22.5798 22.6486 -13.5864 -408 2 3.34474 13.7188 17.8802 2.38023 -0.79805 1.89101 -409 1 0.962462 1.97628 13.8796 24.0866 5.42438 -18.2963 -410 2 1.23331 1.73159 14.7528 2.00372 -3.67266 20.967 -411 2 0.0219615 1.96156 13.879 -26.3344 -0.788872 -2.58417 -412 1 4.34962 0.156713 13.8729 25.4477 -1.51409 -1.97896 -413 2 5.30295 18.5478 13.9084 -21.2168 3.6137 -4.76321 -414 2 3.99528 18.4902 14.7051 -3.29088 -0.042535 8.53213 -415 1 7.35889 1.01117 18.4602 -20.0845 2.29217 31.534 -416 2 7.53777 0.614221 17.6282 1.02155 -13.8743 -28.1328 -417 2 6.39885 0.929085 18.6632 17.4429 7.83311 -8.37388 -418 1 15.8463 18.3909 13.9448 -43.3072 10.6601 -1.92517 -419 2 14.916 18.6906 13.7723 29.0574 -10.6436 -1.66619 -420 2 15.8257 -0.445507 14.8871 10.2412 6.45473 0.424587 -421 1 10.2808 4.63783 16.2194 -42.4572 -26.934 -19.6441 -422 2 11.2059 4.65809 16.3645 33.0638 0.71496 4.62375 -423 2 10.0964 3.70704 15.9214 4.59595 26.5122 11.6188 -424 1 15.903 17.6519 4.47823 -22.6026 32.3058 18.5214 -425 2 16.5145 18.4189 4.46111 -7.58873 -12.9749 2.84853 -426 2 15.0701 18.0221 4.91498 30.26 -18.095 -22.6862 -427 1 6.91987 17.5654 13.9309 41.5981 2.12242 13.325 -428 2 7.49428 17.7119 14.7497 -22.2257 -6.74767 -31.4029 -429 2 7.56851 17.4237 13.1898 -17.2813 4.26485 21.283 -430 1 13.2143 6.40362 6.52296 -17.8609 -7.45559 2.6451 -431 2 14.0836 6.75111 6.37132 17.2928 3.48546 -1.85822 -432 2 12.8363 6.25317 5.64277 2.90235 4.29902 5.97585 -433 1 7.86013 2.26394 9.49062 -8.36252 -9.46169 -35.4407 -434 2 7.29684 2.1706 10.2513 -11.7917 -0.851936 13.7299 -435 2 7.34714 1.87564 8.72892 15.7155 15.0955 20.8405 -436 1 15.1343 14.8378 13.7575 -15.8142 13.0315 4.83039 -437 2 14.8532 15.0481 14.6708 3.35379 -3.45087 -12.098 -438 2 14.5629 15.3828 13.1802 11.493 -9.40285 7.27009 -439 1 9.38118 8.39884 3.83519 4.0123 -7.74443 -2.87465 -440 2 10.2467 8.83344 3.97294 -13.6344 -10.1795 -2.34121 -441 2 9.51993 7.43201 3.84247 0.270426 14.3255 0.324032 -442 1 17.6982 13.5806 16.4882 -11.1823 29.4115 -15.1875 -443 2 16.7477 13.4163 16.452 -1.16521 -4.14372 2.83933 -444 2 17.7994 14.4458 16.0124 3.95943 -25.1425 10.6502 -445 1 4.93057 10.3937 2.82949 21.3493 0.31084 -7.87351 -446 2 5.82872 10.0425 3.0149 -20.5327 4.11374 3.5741 -447 2 4.70497 10.9363 3.59521 3.63155 -1.89772 -0.291932 -448 1 3.65557 8.40975 9.92882 -7.92631 -13.4411 16.4299 -449 2 3.66668 9.34394 9.72247 1.00161 8.70404 1.26029 -450 2 3.36367 8.33438 10.8592 4.36465 5.8519 -13.4993 -451 1 15.9508 6.91708 5.85912 26.4071 -7.62551 -3.83966 -452 2 16.729 7.34279 6.26867 -14.5536 -3.6129 -4.6023 -453 2 16.2929 6.05819 5.53033 -12.7649 13.2481 9.54942 -454 1 15.2478 7.26488 8.9948 -11.5397 21.0457 -23.7706 -455 2 16.0349 7.57374 9.47019 -5.83 4.16597 -2.61919 -456 2 14.9977 7.92652 8.27445 16.2337 -23.38 28.7542 -457 1 6.17715 12.7863 12.74 7.06624 23.8889 14.8517 -458 2 6.98998 12.4152 13.1111 -3.934 -5.41615 -1.6338 -459 2 6.02064 13.6181 13.2483 1.6805 -16.267 -10.1818 -460 1 12.1255 4.53395 13.1266 36.5984 28.8141 18.352 -461 2 12.1988 4.68857 14.088 4.72218 -0.985297 -9.83354 -462 2 11.344 4.04995 13.0228 -42.0246 -23.4808 -8.79261 -463 1 11.4542 8.08345 7.86287 23.2187 -10.867 14.4494 -464 2 12.2022 7.55078 7.50013 -20.6002 10.1652 -0.104446 -465 2 11.6749 8.16233 8.821 -5.77941 1.62242 -23.2927 -466 1 16.9966 10.8 7.60022 14.0465 -17.3895 -10.8701 -467 2 17.6655 10.1188 7.31004 -18.6815 22.6831 6.1404 -468 2 16.8855 11.476 6.90625 3.56282 -12.242 0.823841 -469 1 5.28409 18.0615 10.7272 -25.4136 -4.73004 -4.09376 -470 2 4.85025 17.4105 11.3211 10.0924 14.2936 -14.0097 -471 2 4.61921 18.235 10.0106 18.3134 -6.11244 18.1083 -472 1 7.63344 17.4775 1.60819 -12.3126 -2.35291 35.094 -473 2 8.06049 16.702 1.26786 10.3266 -12.472 -14.3961 -474 2 7.64482 18.174 0.971148 2.96613 14.6858 -21.2308 -475 1 1.92556 12.9088 13.6099 -6.92879 6.84011 17.0322 -476 2 1.40166 12.3078 14.1747 6.51182 9.66465 -5.96466 -477 2 2.01688 13.7519 14.1152 3.80073 -20.221 -11.3532 -478 1 9.32296 6.74742 14.7603 -6.16505 19.9578 -6.21839 -479 2 9.80961 6.04203 15.1542 10.8193 -23.4577 14.2182 -480 2 9.81429 6.97553 13.9666 -4.58884 0.0213979 -5.59057 -481 1 15.2687 4.29028 10.7744 -16.6773 -11.1812 -9.87371 -482 2 16.185 4.03181 10.6852 9.89086 1.55812 4.86514 -483 2 15.2046 4.88146 11.5266 6.28069 5.56792 1.9642 -484 1 11.3833 6.23863 0.0689293 -3.19885 -6.29427 4.65322 -485 2 11.5449 5.27036 18.7473 -10.1654 17.1623 -6.02864 -486 2 10.4171 6.41156 18.6664 16.019 -11.974 -2.10863 -487 1 18.4779 11.4738 14.9298 -4.11302 6.12113 -30.5228 -488 2 18.0937 12.0014 14.1715 8.36132 -18.8326 26.0479 -489 2 18.3027 12.0103 15.7035 0.536699 7.83234 4.13522 -490 1 7.03799 9.27423 7.33397 -11.8444 -18.9096 15.35 -491 2 6.61404 8.50211 7.787 12.2323 17.6714 -16.3801 -492 2 7.97664 9.07639 7.31215 4.33333 -2.45816 -2.54611 -493 1 18.3885 15.3347 12.1965 11.3664 3.9942 -3.56245 -494 2 0.676524 15.5664 11.9851 -14.9026 2.39255 4.26485 -495 2 17.8062 15.8491 11.6143 4.55299 -1.04774 1.98359 -496 1 16.551 4.342 5.30396 -29.3567 -2.30965 40.8017 -497 2 16.5003 4.35995 6.30392 8.99046 -4.55546 -31.3189 -498 2 17.4312 4.58446 5.06774 26.2551 1.0485 -9.7407 -499 1 17.7614 3.18175 10.7726 14.454 -1.68376 5.55906 -500 2 18.6848 3.25815 11.0867 -17.2868 6.635 -4.74284 -501 2 17.731 2.30667 10.3896 -4.78084 -7.5669 -7.23363 -502 1 12.3288 18.6185 10.0887 4.81564 48.0444 9.66027 -503 2 11.5224 0.4701 10.402 18.5752 -22.9317 -12.6203 -504 2 13.04 0.683861 10.1001 -20.831 -28.6711 -0.571217 -505 1 10.4023 9.75891 12.5069 9.56908 10.7357 22.5843 -506 2 11.0968 9.84844 13.1991 -9.82495 1.00858 -15.0243 -507 2 10.3005 8.81694 12.4067 -0.389825 -11.0581 -5.16736 -508 1 0.728244 2.62509 7.20528 10.511 21.9286 8.67284 -509 2 1.10851 3.44304 7.59367 -9.47208 -14.047 -5.98037 -510 2 0.946108 1.9669 7.86838 0.119732 -6.07738 -1.41007 -511 1 0.301432 15.3195 6.88989 15.9737 -48.0831 -14.5816 -512 2 0.502768 15.5752 7.7858 2.08568 -2.79341 12.7124 -513 2 0.620951 14.3521 6.81024 -17.8336 49.2232 -1.9498 -514 1 17.0496 6.91172 14.9593 8.8057 -4.67917 1.70395 -515 2 17.812 7.50707 14.8676 -6.01141 -3.19386 0.836122 -516 2 17.3983 6.09137 15.355 -4.50622 8.29661 -2.9861 -517 1 9.11865 12.5108 8.02933 -49.9881 -7.42173 -16.2711 -518 2 9.47674 11.8107 7.47486 8.95817 -5.21768 -2.38673 -519 2 8.15231 12.5395 7.74329 38.6911 2.79466 15.4325 -520 1 1.1334 1.67756 2.81686 3.27117 15.7614 -6.58164 -521 2 0.957986 2.31477 2.10151 -6.66947 -14.3695 3.78127 -522 2 1.78538 2.12055 3.36586 -0.578909 1.22693 6.40118 -523 1 4.20106 15.0562 10.0364 -13.4085 1.18971 -5.18923 -524 2 3.93003 15.0868 9.10675 3.70212 3.27773 4.96515 -525 2 5.05647 14.6363 10.0432 10.3336 -3.36269 -1.32379 -526 1 7.40784 2.22679 14.822 -4.38879 4.63456 3.27925 -527 2 7.05629 1.62422 14.1639 1.19517 -1.6595 -3.72526 -528 2 7.83793 2.94849 14.3413 -6.72155 -4.85002 1.32971 -529 1 18.3301 14.5327 2.1542 24.8671 -25.4621 4.78212 -530 2 0.57397 14.7195 2.50861 -8.4973 4.51839 -6.64425 -531 2 17.8578 15.3422 2.05909 -12.5294 22.9533 -1.13776 -532 1 10.0489 2.71902 12.9028 6.85621 -14.8278 -12.6664 -533 2 9.96638 2.08865 12.1549 1.47254 10.1846 11.5218 -534 2 9.24995 3.25129 12.8895 -2.74325 3.95657 -0.856162 -535 1 2.95855 8.84401 12.9769 -19.5266 -12.9618 -2.46154 -536 2 3.45638 9.64099 12.8192 4.11354 12.8609 -3.4499 -537 2 3.6113 8.17746 13.175 10.7686 -6.78904 5.39462 -538 1 3.18595 8.60313 3.78164 6.49512 -8.67182 57.5105 -539 2 3.58728 9.20701 3.1814 16.1034 15.9636 -13.6327 -540 2 3.51933 8.8716 4.70776 -18.429 -13.2453 -44.8458 -541 1 5.73851 7.25721 8.5964 -4.13987 -1.96532 11.6754 -542 2 5.69005 6.29369 8.53393 1.30439 2.87011 -1.70973 -543 2 5.04632 7.51192 9.22575 1.66035 -1.11756 -5.95213 -544 1 14.9081 1.62503 1.83745 -8.73365 -28.3512 -14.8102 -545 2 15.1675 2.29904 2.4498 2.46531 19.8996 4.15138 -546 2 15.1848 1.81402 0.924567 6.2551 4.83326 15.3454 -547 1 8.63912 15.0489 0.67096 1.85438 -3.84451 5.87273 -548 2 9.43742 14.948 1.21756 -6.6173 4.03251 -1.68679 -549 2 7.96284 14.4978 1.10066 2.22069 5.93818 -4.9944 -550 1 15.4364 1.44293 7.19944 -29.9197 -3.33934 -17.0244 -551 2 14.7125 0.994492 6.68707 24.0317 7.87524 16.0302 -552 2 15.0797 2.33705 7.33252 4.46076 -6.95989 4.74521 -553 1 4.93029 12.8913 18.4644 10.9792 1.21933 18.1223 -554 2 5.27563 12.987 0.740174 -6.01723 -1.47567 -19.726 -555 2 5.68015 13.1369 17.9044 -5.07302 3.16897 2.74711 -556 1 15.3923 8.68146 18.054 15.694 19.9465 -16.5309 -557 2 15.9315 9.21769 17.4147 -18.0717 -17.5644 15.7946 -558 2 15.1857 9.29971 0.121687 -1.56315 -2.75746 2.59172 -559 1 11.9784 3.14039 18.3403 11.1408 -7.29272 18.8649 -560 2 12.1001 2.9975 0.653392 -4.70819 -0.503108 -12.7749 -561 2 12.4778 2.40933 17.9385 -7.35096 7.48199 -3.86664 -562 1 13.1896 12.7267 5.18606 4.81883 -3.59528 0.0329893 -563 2 13.4958 11.8346 4.97314 2.3467 3.28367 -0.068752 -564 2 13.4618 12.8881 6.09814 -4.13789 -2.12194 -0.520265 -565 1 6.18108 7.13483 0.245639 -8.98659 -24.3205 -5.24363 -566 2 6.15368 8.0627 19.0493 5.02048 26.2765 -0.395042 -567 2 5.28324 6.84248 0.444666 1.40419 -2.69741 2.9636 -568 1 17.7469 15.8806 14.9091 -16.6307 4.82259 1.60218 -569 2 16.7811 16.0196 14.9781 16.1488 -1.66255 -6.01934 -570 2 17.9228 15.7652 13.9648 -0.217809 -0.705292 2.49903 -571 1 13.1074 0.925484 16.7107 3.18003 -6.63181 9.52558 -572 2 14.0398 0.701227 16.9047 -10.9319 3.14101 -7.94235 -573 2 12.6435 0.0729893 16.6565 6.11054 4.53406 -2.82687 -574 1 10.8779 14.5049 7.42771 23.1657 22.4115 -16.2389 -575 2 10.1426 13.9786 7.6854 -20.2069 -15.6201 11.4355 -576 2 11.6544 13.9411 7.50544 0.873985 -2.97227 1.69423 -577 1 17.7332 8.41688 2.16357 9.83329 25.3003 13.1733 -578 2 16.8474 8.49196 2.51389 -11.5025 -5.56634 1.51969 -579 2 17.684 7.86174 1.40275 -6.79002 -17.3841 -17.6814 -580 1 12.5241 7.78132 2.0423 -1.44154 17.0415 -14.1456 -581 2 12.3356 8.69211 1.74465 0.56853 -10.9135 10.1338 -582 2 12.0507 7.22418 1.41137 4.13261 -1.84431 -3.3422 -583 1 12.0402 14.5123 10.5082 -18.3289 -2.04433 -49.0296 -584 2 12.3885 14.3833 9.58045 -11.5085 2.39427 35.0464 -585 2 11.0712 14.6752 10.3612 24.5139 -2.29095 9.58119 -586 1 6.7433 6.75035 15.5111 8.69017 25.9379 21.8943 -587 2 7.64047 7.11596 15.2998 -22.3365 -16.355 4.27733 -588 2 6.42641 7.26782 16.2896 9.37622 -14.6905 -17.8302 -589 1 7.9604 4.42511 13.2728 28.7823 16.7879 24.018 -590 2 7.37747 4.63038 12.5661 -23.4436 4.48442 -18.6585 -591 2 8.25373 5.30295 13.5968 -1.99494 -17.578 -1.9241 -592 1 13.2943 12.2257 14.4027 3.56556 -5.33332 1.41443 -593 2 13.2861 11.2546 14.3815 -5.78887 6.10336 -0.82645 -594 2 13.6298 12.4878 13.5348 -0.194802 0.853385 3.24808 -595 1 14.4975 9.60743 7.32851 -1.81828 -22.5371 -11.9494 -596 2 15.283 10.0905 7.53237 20.8949 12.3364 4.94663 -597 2 13.7862 10.0745 7.73482 -16.3884 10.3496 13.6544 -598 1 12.6855 16.7955 3.35468 10.446 54.0378 -9.24021 -599 2 12.8247 17.4169 4.11373 -2.43161 -22.9959 -18.5255 -600 2 12.7287 17.4093 2.56008 -5.07923 -25.2307 27.5772 -601 1 0.985851 7.00227 17.3383 1.31889 9.4813 -6.51378 -602 2 0.174673 6.82729 17.8428 -2.72668 6.21708 -7.63644 -603 2 0.788987 7.63656 16.6124 1.43967 -10.9643 14.4702 -604 1 12.9703 4.85252 15.7444 36.7131 7.67865 -11.6648 -605 2 13.7444 4.28338 15.4912 -28.1266 12.6425 14.7219 -606 2 13.3848 5.73698 15.8318 -12.3641 -9.92719 -0.136909 -607 1 2.31739 3.41657 5.06312 -13.6796 12.8802 45.0615 -608 2 1.71742 3.03519 5.77756 22.5616 7.27981 -29.9715 -609 2 2.67638 4.25091 5.49055 -8.69432 -27.9074 -22.1065 -610 1 8.14626 10.9014 13.7501 23.1519 -21.2188 51.9658 -611 2 8.18961 10.6456 14.7569 -3.14293 16.1916 -66.8861 -612 2 8.91613 10.442 13.3487 -9.38929 12.2654 3.7561 -613 1 12.9965 1.57692 13.2293 -13.236 30.2614 -33.2276 -614 2 13.5053 1.61767 12.3799 -8.92772 -10.8244 27.0208 -615 2 12.3556 2.33631 13.1194 22.5086 -26.9187 11.5847 -616 1 6.63966 13.684 2.03193 -11.5531 1.65982 24.7971 -617 2 6.01437 14.0711 2.69678 13.9712 -7.1585 -19.9778 -618 2 7.21702 13.1132 2.57076 -4.92077 5.61769 -6.96253 -619 1 15.813 6.37449 12.4855 -26.0384 -19.2076 5.56376 -620 2 16.3133 6.94665 11.9354 17.458 16.492 -16.919 -621 2 16.1081 6.5465 13.3734 10.1637 1.50607 12.5345 -622 1 16.7517 0.683836 9.54032 9.17465 -17.8268 3.86543 -623 2 16.8312 18.3701 9.76674 -11.2714 16.7378 -3.92594 -624 2 16.3182 0.76443 8.67683 0.0107679 -1.03064 0.242674 -625 1 6.19528 11.6935 8.23629 -2.98771 -55.3704 13.0415 -626 2 5.39217 11.4329 8.74625 16.1659 14.5788 -12.0119 -627 2 6.59624 10.789 8.03203 -10.8651 41.6219 1.75135 -628 1 2.78257 8.63233 0.349942 -51.0927 -6.02203 -19.4773 -629 2 2.14734 8.16991 18.3384 31.254 20.3071 31.1367 -630 2 2.20011 9.24624 0.868363 16.6862 -13.9373 -14.0055 -631 1 10.0933 10.2699 6.60791 4.69659 2.91801 -6.95173 -632 2 10.6585 9.65933 7.0984 -2.33853 -1.64778 -0.152736 -633 2 10.478 10.3114 5.71024 -7.38541 0.394324 12.3102 -634 1 6.85971 15.7454 6.78123 4.24276 8.06212 3.90305 -635 2 7.14611 16.2575 7.56121 -6.95129 -7.98507 -8.49325 -636 2 7.04221 16.3283 6.02778 -2.00154 -5.2395 1.03704 -637 1 6.5672 12.9167 5.89107 0.597921 -4.77378 -3.41809 -638 2 6.75629 13.7931 6.22612 0.282518 9.70238 2.49815 -639 2 6.16516 12.4266 6.61937 1.75727 3.9196 -1.62353 -640 1 16.7395 12.5246 9.74847 -3.06854 -10.3396 -13.3378 -641 2 16.803 11.7934 9.09918 0.0574675 11.3505 13.7779 -642 2 17.2471 13.2388 9.35461 0.0307086 0.265441 4.69208 -643 1 6.27963 2.83254 2.76143 -4.73524 -28.0523 14.6006 -644 2 6.37898 3.73989 2.5277 5.16678 22.951 -10.7112 -645 2 5.79937 2.39077 2.0523 -0.657158 4.14199 -3.99187 -646 1 10.6834 2.9997 3.2493 -4.30343 6.66703 3.45031 -647 2 10.3389 3.87773 3.47337 -2.10815 -7.43082 -2.74741 -648 2 10.1644 2.67816 2.50044 1.52937 0.706493 -1.87803 -ITEM: TIMESTEP -100 -ITEM: NUMBER OF ATOMS -648 -ITEM: BOX BOUNDS pp pp pp -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -0.0000000000000000e+00 1.8643000000000001e+01 -ITEM: ATOMS id type x y z fx fy fz -1 1 8.77244 6.59569 17.9763 -3.45079 -15.6041 -9.13306 -2 2 7.88004 6.49722 18.3444 6.65526 3.83231 -3.73646 -3 2 8.88832 5.875 17.3232 0.339998 10.7344 11.2284 -4 1 0.232197 8.43163 6.74931 6.06809 -9.75314 40.4456 -5 2 0.255717 8.25928 5.82997 0.568886 -7.03857 -37.2819 -6 2 0.690537 7.6579 7.15764 -12.6716 20.3857 -3.7924 -7 1 8.73054 0.448274 6.96197 0.757688 5.19807 -2.99354 -8 2 9.64384 0.493158 6.62895 -11.5479 0.592924 -0.0248858 -9 2 8.1978 0.998025 6.35807 9.15448 -7.13553 5.61176 -10 1 6.40593 1.75267 11.8149 38.8296 -3.08614 -8.28972 -11 2 5.81968 2.38515 12.1727 -25.8813 19.5399 13.38 -12 2 5.91601 0.958217 11.6787 -14.9693 -21.4487 -5.83463 -13 1 6.93553 5.46707 2.3717 -29.4847 3.29264 10.9289 -14 2 6.2293 5.77948 3.0367 33.3819 -5.43232 -34.2308 -15 2 6.73101 5.82483 1.47662 0.276644 1.33511 28.97 -16 1 16.2706 10.1725 16.0328 16.576 -12.0275 -13.9735 -17 2 17.1689 10.3287 15.6909 -13.6837 1.56601 5.28727 -18 2 15.9002 11.0264 16.2303 -5.40144 13.1923 2.47446 -19 1 10.8573 14.9713 2.3127 -4.53536 -0.807355 -13.4682 -20 2 10.8458 14.5197 3.15612 -3.95698 -5.41896 6.20362 -21 2 11.2908 15.8056 2.48855 3.23834 4.77246 6.19277 -22 1 17.2232 8.21136 11.0033 2.73792 2.45641 -7.11401 -23 2 16.6726 8.88418 11.4331 2.86084 -2.93597 -0.581414 -24 2 17.9525 8.69866 10.5809 -6.6523 -2.55116 4.88578 -25 1 14.5937 16.0509 16.2923 16.8919 1.55785 -12.0612 -26 2 13.6919 16.3738 16.3176 -7.99874 0.738503 2.77307 -27 2 14.7362 15.4806 17.0483 -6.38665 -4.70858 10.3974 -28 1 12.1782 13.2488 0.556058 -6.41896 9.17153 -4.9038 -29 2 11.8393 13.4134 18.3136 3.64438 -6.73296 -6.87976 -30 2 11.6781 13.8768 1.08938 4.30308 -0.940018 9.70193 -31 1 9.32636 5.50189 3.85673 -23.6707 -6.9557 11.6523 -32 2 8.85207 5.35955 4.73387 10.6863 3.91607 -36.7024 -33 2 8.65492 5.41152 3.1282 11.356 3.18621 25.5004 -34 1 1.53424 3.89903 11.544 -4.66799 23.5976 14.1629 -35 2 1.33558 4.79151 11.9229 9.77101 -18.0042 -9.49869 -36 2 1.78943 3.33535 12.2834 2.68741 0.460061 1.88957 -37 1 2.11036 6.99869 8.11066 2.48315 -17.2899 2.96853 -38 2 2.57184 7.49315 8.78305 3.29023 12.1045 5.89357 -39 2 2.1177 6.10606 8.48449 -3.4025 -1.3508 -8.01694 -40 1 5.18347 4.46977 7.78792 -2.57538 4.03359 -5.12796 -41 2 5.37117 3.51932 7.65443 -4.82345 11.4027 -0.558597 -42 2 4.53495 4.79047 7.12216 11.4175 -13.4448 8.55636 -43 1 3.42716 2.88114 17.3924 1.12201 37.8538 -2.09818 -44 2 4.03218 3.21565 16.6954 -8.80258 -2.8612 13.6459 -45 2 2.96175 3.68375 17.7714 12.3959 -28.5801 -12.8282 -46 1 7.56049 5.45137 6.19682 -11.2764 11.7759 39.3451 -47 2 8.17338 6.02323 6.733 -17.9712 -15.9787 -15.2388 -48 2 6.83707 5.19934 6.84169 25.8687 -1.03041 -23.6459 -49 1 9.81873 7.03274 12.0818 18.6926 1.80354 21.1658 -50 2 10.1168 6.17447 11.801 2.37707 -8.57843 -5.75387 -51 2 9.13705 7.28384 11.4839 -21.9155 5.9942 -18.2818 -52 1 13.9782 3.81734 8.11005 -6.38125 -7.14222 -11.0636 -53 2 13.4268 4.53125 7.77431 4.97705 1.71109 -4.47031 -54 2 14.3288 4.12395 8.93436 6.50574 7.00298 17.9277 -55 1 4.54162 17.1358 3.87887 10.9044 35.7056 -0.341992 -56 2 5.36932 17.5648 4.19271 -11.2647 -17.0231 -6.60056 -57 2 4.14672 17.8103 3.27983 -0.0256371 -21.9717 9.98561 -58 1 16.2123 16.5489 10.6095 26.1835 -5.76397 -19.4616 -59 2 15.4589 16.7003 11.1416 -23.8325 7.35421 23.2226 -60 2 15.8886 15.8767 10.0022 2.98718 1.98497 -7.14015 -61 1 1.93449 4.79928 0.00082377 17.3961 -4.98991 5.57961 -62 2 2.67896 5.07161 0.592242 -22.0191 7.26131 -10.4701 -63 2 1.68005 5.53286 18.0583 5.78187 -2.17332 10.5029 -64 1 11.1761 13.3033 16.4476 20.6858 -29.5101 -20.5449 -65 2 10.7502 12.4348 16.5818 -0.505604 15.8506 2.04497 -66 2 11.8189 13.0874 15.7254 -14.483 14.0049 15.9552 -67 1 10.0082 10.9133 16.7377 -9.76065 -12.5647 6.43928 -68 2 10.4104 10.0696 17.0143 -3.0625 14.8211 -5.5238 -69 2 9.04798 10.758 16.6751 14.6534 4.77532 0.819581 -70 1 11.8926 17.5507 13.5059 -15.5524 -14.4544 -0.25773 -71 2 12.4585 17.1847 12.8152 4.41482 5.53476 3.60851 -72 2 11.9755 18.5016 13.5139 9.00416 11.9454 -7.12981 -73 1 6.39659 9.54323 12.3526 -12.6063 6.46711 4.93213 -74 2 6.97402 9.29797 11.635 9.25294 -5.21247 -6.5221 -75 2 6.9248 10.0607 12.9773 -1.49192 -5.83682 -8.37915 -76 1 16.2827 12.8664 2.8283 0.430065 -24.2056 0.300325 -77 2 17.1271 13.2094 2.55074 10.9303 3.80489 0.0707423 -78 2 15.7284 13.6342 2.87288 -15.0446 12.1841 2.12753 -79 1 0.782434 12.8185 5.85612 -33.4557 3.27495 -26.778 -80 2 1.12737 12.9122 4.94214 -3.16706 -8.15793 13.9432 -81 2 18.4302 12.7528 5.74133 33.3816 -1.67566 5.80796 -82 1 5.29416 16.3645 18.462 -0.365113 -1.85929 1.37874 -83 2 5.65117 15.5929 17.9841 -1.41418 12.24 9.00358 -84 2 5.90904 16.5787 0.535619 -2.78951 -3.81837 -4.76209 -85 1 0.717617 7.68269 4.16298 45.78 12.5398 -25.9452 -86 2 0.140595 7.95484 3.42088 10.68 -3.85526 14.32 -87 2 1.67421 7.98176 3.89702 -61.12 -15.169 17.2669 -88 1 3.20538 9.16537 6.53153 -16.7997 -26.3462 11.633 -89 2 3.63886 8.66012 7.25517 -10.7634 14.1338 -16.8685 -90 2 2.28456 8.785 6.4428 29.8979 17.6904 5.8263 -91 1 7.3492 10.4558 16.1821 -32.1717 -5.51262 30.2531 -92 2 6.6595 11.1272 16.0448 13.9154 -6.26319 -1.99334 -93 2 7.03952 9.99344 16.9918 7.69449 10.9592 -10.5833 -94 1 10.9926 0.857119 5.02234 -5.32556 5.69944 -21.4369 -95 2 11.0071 1.72344 4.58448 5.20867 -2.07691 11.6276 -96 2 10.6449 0.320945 4.28448 4.96755 -3.65716 14.4683 -97 1 4.17972 2.99732 13.1563 8.08367 -30.8511 5.02994 -98 2 4.53886 3.3528 13.9956 -8.94088 -10.2248 -10.148 -99 2 4.12323 1.98418 13.2207 2.50903 42.0947 6.54014 -100 1 8.52337 10.2728 1.80778 10.3789 -10.908 24.8689 -101 2 8.43412 10.9106 2.54849 -2.4679 -8.46295 -11.8092 -102 2 8.72683 9.4118 2.24878 -4.48166 20.4458 -7.62428 -103 1 10.3146 1.66303 15.4651 0.0280032 6.46587 3.16016 -104 2 11.2365 1.5769 15.7049 7.71736 -2.87845 -0.628854 -105 2 10.2832 2.03916 14.5766 -0.873711 -2.30994 -1.44208 -106 1 2.60872 12.9688 7.93078 -1.0685 2.90827 1.70102 -107 2 3.08524 13.7852 7.70925 1.81136 -8.54773 -5.41906 -108 2 2.07592 12.7429 7.1537 2.1601 3.22826 4.8584 -109 1 3.84139 11.714 4.98357 -9.2182 -6.48315 2.00023 -110 2 3.59649 11.1336 5.73363 3.13206 7.92599 -15.0555 -111 2 3.08391 11.75 4.36582 7.48234 -0.753218 11.1676 -112 1 6.65636 14.539 16.9808 1.14971 -3.74934 -0.345026 -113 2 7.45699 15.0461 17.1534 0.734042 -3.82079 -1.22553 -114 2 6.35462 14.7758 16.0963 4.10604 -0.420587 -1.60546 -115 1 14.2186 14.4753 3.18712 8.31434 -1.03143 -11.3814 -116 2 13.7635 15.2982 3.34662 -3.59872 10.6386 -1.06184 -117 2 13.8465 13.8568 3.80574 -6.38377 -9.35153 11.7656 -118 1 8.76639 18.036 16.1575 -17.2352 -7.71273 4.18589 -119 2 9.29865 17.253 16.446 -1.99578 26.3863 -16.3924 -120 2 9.21082 0.13577 15.7005 10.7734 -16.3176 12.3305 -121 1 4.70057 1.84937 4.90583 -5.59427 22.8387 -36.2464 -122 2 3.793 2.25175 4.86575 28.8401 -10.2604 4.23254 -123 2 5.1801 2.18711 4.08016 -18.9233 -12.3263 38.2061 -124 1 15.0501 12.6021 16.5687 -12.0311 0.26828 5.88874 -125 2 14.6786 12.8761 17.4109 9.53333 3.55003 6.01908 -126 2 14.2645 12.5148 16.0221 4.98358 -1.43573 -15.5641 -127 1 15.7004 18.5129 16.8573 39.713 -3.42746 23.3516 -128 2 16.4681 18.7143 17.5055 -38.5977 -15.0096 -30.817 -129 2 15.6109 17.5396 16.7903 -2.54574 14.9499 6.02131 -130 1 1.36802 1.35817 16.6529 -7.19601 7.74866 13.6684 -131 2 2.15913 1.86948 16.876 -3.57304 -8.28302 -6.01627 -132 2 0.751389 1.61649 17.3659 4.93092 -7.13328 -12.7379 -133 1 18.2443 4.33431 15.8699 4.87602 -2.4936 -15.9817 -134 2 17.8369 3.63124 15.3424 2.32992 6.4949 4.25729 -135 2 0.452078 4.51482 15.4394 -9.42811 -2.49011 8.2103 -136 1 12.0529 17.1173 16.1421 -28.5646 -13.5401 15.8604 -137 2 11.3287 16.6705 16.6559 24.6179 11.2855 -13.6919 -138 2 11.708 17.1501 15.239 10.7504 0.848438 1.34073 -139 1 16.0751 2.69533 18.2299 -16.8426 22.7601 -19.9608 -140 2 15.7518 3.52741 18.6545 8.16925 -19.768 -14.2608 -141 2 15.768 2.75869 17.2894 6.47211 -5.43997 24.4047 -142 1 6.70105 13.7211 10.0493 -2.92253 -3.29615 13.924 -143 2 6.49616 13.3451 10.9223 2.46715 2.87816 -3.90822 -144 2 6.5701 13.0016 9.42848 5.58743 -2.71244 -4.10916 -145 1 10.1642 18.4563 2.66846 -6.4553 9.35236 -16.0973 -146 2 10.4494 0.522706 2.05557 -0.598662 -14.7868 7.93587 -147 2 9.23943 18.2921 2.43567 5.35466 0.524311 4.08806 -148 1 3.08905 17.6286 6.23363 28.1073 -1.15148 23.9606 -149 2 2.19758 17.5876 5.91536 -10.6529 4.22104 -18.8026 -150 2 3.7136 17.7221 5.50184 -12.297 -3.14114 -7.6924 -151 1 12.6187 16.7784 7.83399 -8.24743 2.38577 1.37984 -152 2 11.9273 16.0794 7.74003 7.37944 21.7069 5.85683 -153 2 12.3535 17.4638 8.48865 -0.622135 -17.7991 -6.24189 -154 1 14.8741 15.2807 8.33754 11.6667 3.93031 -5.87838 -155 2 14.2607 15.9458 8.0029 -4.6938 -2.09697 8.01324 -156 2 15.5465 15.2244 7.63778 -8.32879 0.363275 5.25782 -157 1 17.8358 18.3077 0.207666 -46.6557 3.82667 -12.4063 -158 2 18.5381 17.6928 0.20107 34.3258 -19.0599 -1.41311 -159 2 18.1099 0.429917 0.68066 12.6369 19.0779 11.4558 -160 1 0.768971 10.519 1.45234 -14.3967 -19.3664 19.1268 -161 2 -0.0407552 10.0454 1.78172 23.5075 9.70284 -14.2764 -162 2 0.503185 11.1892 0.827858 -7.10365 8.12718 -9.46819 -163 1 1.82037 12.3064 3.2607 -0.411525 2.12628 17.6018 -164 2 1.36119 11.682 2.70611 -2.67447 -10.2614 -7.1426 -165 2 2.03731 13.0482 2.69872 0.079619 5.20365 -3.96737 -166 1 0.725717 17.3003 4.98992 32.4002 3.58468 -34.9181 -167 2 -0.000639544 17.8885 5.08952 -19.7566 14.3988 12.6832 -168 2 0.713313 16.5777 5.58791 -15.4184 -21.9192 25.4801 -169 1 0.951486 0.797441 9.37101 14.826 11.188 -16.0996 -170 2 1.14791 0.588384 10.2838 -3.41112 -8.44303 11.2353 -171 2 0.0745467 0.497625 9.13864 -8.88294 -4.64793 9.22513 -172 1 16.8073 2.38946 13.4769 5.39787 -10.4284 -8.99471 -173 2 17.0506 2.69304 12.5747 -8.0967 -7.05722 13.8788 -174 2 16.5161 1.45381 13.4188 4.66162 13.0486 -2.08534 -175 1 2.62912 16.0502 12.0784 8.40953 -12.472 -10.7904 -176 2 3.04385 15.7269 12.8881 -2.37218 0.184289 -5.79457 -177 2 3.10949 15.6337 11.3228 -8.7582 6.42497 16.6586 -178 1 16.3457 15.4302 6.12389 30.9011 24.8554 -18.1041 -179 2 17.2992 15.5349 6.36757 -22.0844 -7.23183 -0.993592 -180 2 16.19 16.1865 5.50068 -1.85714 -20.6143 14.9819 -181 1 5.77873 5.21745 11.785 11.0193 -20.9315 -11.6683 -182 2 5.50793 5.92484 12.3546 -4.36629 16.5013 7.19057 -183 2 5.27867 4.45162 12.0794 -6.37659 -1.59945 -1.70387 -184 1 15.1747 4.94504 0.761547 -29.5175 -4.13494 28.6724 -185 2 14.9952 4.57194 1.67189 6.69018 16.901 -24.5633 -186 2 14.3176 5.30548 0.449447 18.0211 -8.94221 4.63226 -187 1 16.4144 16.461 1.77501 8.34865 -5.69196 -8.65308 -188 2 16.356 16.7636 2.67626 -8.71628 3.92983 13.8981 -189 2 16.7832 17.2073 1.29403 -0.614878 1.7319 -3.63708 -190 1 0.136057 4.8659 3.98965 34.6037 22.2365 -2.60366 -191 2 0.554963 5.79058 3.9624 -19.788 -38.6093 6.27627 -192 2 0.840291 4.21253 4.20207 -10.6708 20.7839 -4.14843 -193 1 2.91044 15.0804 15.1041 7.34684 -10.5058 14.2682 -194 2 2.90482 14.7198 16.034 -7.41786 16.0657 -24.8201 -195 2 2.46761 15.9418 15.099 -2.49045 -2.68752 9.6724 -196 1 0.98952 14.6361 9.40184 3.41519 -3.90395 6.55514 -197 2 1.54705 13.945 9.00075 -6.08548 3.23571 10.1521 -198 2 0.78947 14.3674 10.3125 0.535168 -4.82993 -11.1122 -199 1 13.5676 16.5089 11.5672 -19.673 9.58551 -20.9583 -200 2 13.2883 17.2623 10.9814 5.35041 -18.2182 15.9177 -201 2 13.0352 15.7491 11.2513 9.15027 7.77217 2.32965 -202 1 4.84709 1.60354 0.665871 -13.2454 -7.94988 -14.2061 -203 2 4.37724 2.10746 -0.0295305 4.1335 -5.07179 15.4313 -204 2 4.23428 0.890311 0.93575 7.29231 10.3056 3.49355 -205 1 1.57562 18.6232 11.9448 -9.54215 3.4719 -19.1533 -206 2 1.53947 0.452662 12.7669 0.622104 8.67092 13.3018 -207 2 1.94164 17.7639 12.1401 7.67295 -5.68018 1.31967 -208 1 11.3828 10.0809 4.23132 25.5406 -0.783734 -33.5194 -209 2 11.2477 10.3841 3.29047 7.40472 -5.62792 30.1478 -210 2 12.3604 9.90108 4.31318 -36.068 9.82931 1.34024 -211 1 8.1924 12.225 3.79726 -5.69748 14.5101 56.1678 -212 2 9.05523 12.5573 4.13122 -12.2475 -6.42112 -18.1901 -213 2 7.61811 12.3317 4.63279 18.664 -10.6547 -44.172 -214 1 14.6446 4.04033 3.3856 3.29585 4.20735 14.8065 -215 2 15.1799 4.13354 4.21231 -10.8641 -1.34483 -21.0767 -216 2 13.7289 4.27483 3.60977 8.83721 -0.102893 1.13309 -217 1 5.73789 1.70847 7.633 -45.2268 -33.2589 19.0394 -218 2 5.00558 1.12579 8.07813 40.2552 34.7696 -21.6936 -219 2 5.52319 1.67762 6.69069 2.06189 0.609235 -2.30714 -220 1 17.8554 0.94247 4.83325 2.84508 1.94772 -6.32822 -221 2 18.4375 1.13729 4.06994 -6.68522 3.20321 14.3473 -222 2 17.8361 1.70281 5.4359 2.52705 -5.98387 -7.60558 -223 1 6.82607 9.13014 4.53731 -2.03949 -2.27606 -0.824268 -224 2 6.749 9.37751 5.45829 -4.27203 4.05265 7.19029 -225 2 7.76352 8.95198 4.44117 4.86868 -1.78157 -6.05796 -226 1 2.39805 14.6397 2.05874 17.0918 -1.49078 4.46086 -227 2 3.17145 14.6314 2.66377 -10.8679 0.525641 -12.6634 -228 2 2.72903 14.4183 1.17543 -1.81421 4.03234 5.90777 -229 1 17.1796 12.9575 13.0281 -10.0626 2.91445 0.0973403 -230 2 16.3048 13.3397 13.2675 20.7192 2.62525 -4.36947 -231 2 17.7682 13.6617 12.6978 -15.1419 2.46765 5.43564 -232 1 14.7925 10.5715 1.51204 -8.6843 -36.4521 -19.1925 -233 2 15.3686 11.2103 1.85793 27.186 33.4644 17.5702 -234 2 13.9217 10.9161 1.62765 -18.2001 7.18743 0.677482 -235 1 5.63756 6.65584 4.53835 -5.70194 -14.7917 8.95129 -236 2 5.96892 7.55557 4.50237 4.06113 5.5935 -1.33512 -237 2 6.19689 6.19506 5.18786 2.48768 6.43185 -8.34619 -238 1 8.1035 8.32015 10.3633 -6.06951 -1.51391 13.5103 -239 2 8.71051 8.88696 9.88772 3.75134 6.39998 -5.242 -240 2 7.4427 8.01108 9.7382 -0.891776 -1.59521 -4.95879 -241 1 13.4554 18.4382 5.64567 -23.0826 -2.6609 26.3697 -242 2 12.6541 0.350227 5.51512 12.1971 -9.37205 -2.29397 -243 2 13.2308 17.8847 6.43702 5.12544 9.06169 -21.995 -244 1 0.0481459 2.53289 0.450073 0.762545 20.3906 -8.36614 -245 2 17.7393 2.57826 18.829 23.3906 9.65711 1.86789 -246 2 0.50996 3.41343 0.303855 -21.6669 -27.8541 1.68488 -247 1 12.9745 10.8048 9.65469 -32.5048 41.5261 -13.285 -248 2 12.0083 11.0976 9.65119 33.8953 -25.1931 3.11551 -249 2 13.0333 9.87229 9.85209 -8.8072 -6.07099 4.09073 -250 1 0.527116 12.3319 11.2575 10.4347 -0.622496 2.4881 -251 2 18.2313 12.2915 11.4294 -10.2968 -1.46033 -6.74513 -252 2 0.909084 12.5363 12.117 7.12796 0.366826 -3.41572 -253 1 5.28415 7.34725 13.2845 -6.32664 2.65038 2.55184 -254 2 5.64713 8.17412 12.9655 4.82658 4.12789 -9.57053 -255 2 5.74627 7.2293 14.1116 0.316635 -7.58532 9.69513 -256 1 1.16454 6.74183 12.03 -13.1625 -42.3004 -9.02199 -257 2 0.295417 6.98712 11.7254 -9.09418 5.46945 -3.0829 -258 2 1.57891 7.53521 12.2772 19.8541 36.5775 12.6901 -259 1 15.5783 9.75012 12.4577 9.71681 16.8235 16.5595 -260 2 15.2431 10.6351 12.2158 0.950441 -15.6258 3.07953 -261 2 16.0853 9.89705 13.2804 -12.0519 -4.92211 -13.1427 -262 1 16.5993 12.6285 5.60521 -10.2494 37.6021 -45.7262 -263 2 16.4242 13.6113 5.62967 5.67224 -29.3823 14.3376 -264 2 16.441 12.4706 4.63081 7.92181 -5.25591 31.2114 -265 1 6.41284 9.90681 0.119653 0.515871 -10.7086 -9.9123 -266 2 5.64934 10.3727 0.465056 -3.06655 2.33505 3.46562 -267 2 7.14462 10.1266 0.702846 2.16363 1.41956 4.36049 -268 1 12.2095 5.93838 4.00309 -11.5544 -2.90268 -3.08172 -269 2 12.2942 6.66752 3.37735 2.08742 0.382808 1.33145 -270 2 11.2587 5.74648 4.01779 6.74513 0.670066 1.17813 -271 1 0.342924 12.9268 0.00967172 -2.71894 -2.13654 5.95194 -272 2 18.7348 13.4393 0.793746 3.88983 0.588143 -5.53597 -273 2 18.4589 13.2921 17.9296 1.41778 -5.28425 5.34754 -274 1 3.57599 18.7244 8.67011 -7.57313 7.8026 -17.3863 -275 2 3.53053 18.3214 7.79351 4.94999 -5.98969 2.51912 -276 2 2.6975 0.472694 8.72681 1.72246 -0.921876 11.7862 -277 1 7.19816 17.4543 4.42938 13.0422 27.6578 -13.842 -278 2 7.51541 18.3714 4.6455 -6.70989 -26.1973 -6.43912 -279 2 7.34255 17.3635 3.4592 -3.95356 0.0926602 20.0901 -280 1 9.24276 17.181 12.1874 27.1924 -9.91753 -12.8104 -281 2 9.16544 16.536 11.4403 4.06483 10.4089 22.9332 -282 2 10.1989 17.1789 12.4847 -33.3611 -0.423317 -5.22003 -283 1 13.2427 13.2324 7.99028 -4.63127 -11.2433 10.7708 -284 2 13.2975 12.5097 8.63573 0.309708 1.2863 -7.28868 -285 2 13.9184 13.8596 8.25103 7.01778 4.96536 -0.211076 -286 1 14.7706 2.86972 15.5058 12.3246 -20.976 -18.3849 -287 2 14.0341 2.28041 15.2496 10.8751 5.18171 6.07562 -288 2 15.4548 2.72916 14.8136 -15.3015 9.06101 10.4071 -289 1 9.96013 15.6554 16.9624 -0.416257 -4.3558 -3.6035 -290 2 10.3061 14.8055 16.6414 -1.75696 6.53817 2.71112 -291 2 9.61308 15.4752 17.8389 -3.07369 -3.40172 1.73448 -292 1 11.2206 8.54091 16.6271 11.2119 0.246209 -0.153837 -293 2 10.3853 8.13843 16.425 -12.7378 -7.75768 -8.20822 -294 2 11.7159 7.85532 17.0695 3.92811 -4.5145 7.83184 -295 1 4.19128 18.3534 16.7936 -2.0541 -15.6573 2.75359 -296 2 4.49896 17.6946 17.4386 1.3239 2.14246 -6.87061 -297 2 4.3476 0.553135 17.2025 -0.294224 9.43754 2.6314 -298 1 2.38271 4.321 8.90759 20.0465 -16.3105 29.2362 -299 2 3.33364 4.03277 8.87737 -27.5446 13.4253 -3.78204 -300 2 2.08958 4.1083 9.83354 7.71669 6.29647 -26.7475 -301 1 9.9842 10.4369 9.88352 -17.0195 21.6351 -0.0387615 -302 2 9.44133 11.1731 9.47934 17.4922 -21.0458 18.4718 -303 2 9.94225 10.4854 10.8652 2.27572 1.94662 -18.6097 -304 1 9.85899 0.920399 10.8075 0.162278 -2.63975 1.09763 -305 2 9.48302 0.0750215 11.0855 -2.58178 2.3482 3.77053 -306 2 9.21377 1.33985 10.2254 -0.0206645 -1.54215 -2.59695 -307 1 9.16055 15.229 10.2075 -19.4407 -6.65372 -14.862 -308 2 8.92137 15.8821 9.51239 -0.317996 -13.1788 14.0466 -309 2 8.43697 14.5477 10.1944 18.1534 21.6077 -0.815821 -310 1 0.71674 9.75329 10.1461 2.10813 23.2969 8.50765 -311 2 0.819344 10.7283 10.3167 -3.94998 -28.3852 -4.44668 -312 2 1.15296 9.53542 9.32246 0.728257 4.55427 -3.87479 -313 1 17.2456 4.88922 8.01698 -15.6269 -0.477795 25.7007 -314 2 16.4423 5.19943 8.52213 28.7194 -9.29348 -15.89 -315 2 17.7804 4.31587 8.60398 -15.5446 9.64156 -7.98894 -316 1 14.822 14.6129 0.044879 1.26259 -7.26488 27.1569 -317 2 15.5503 14.8635 0.654609 -16.5042 1.70925 -13.2775 -318 2 14.1019 14.3181 0.644441 11.2495 5.19015 -13.4399 -319 1 3.93398 11.151 9.56657 -13.0999 1.1143 6.92396 -320 2 3.8819 11.1389 10.5379 -0.108421 8.58768 -6.25849 -321 2 3.2885 11.8101 9.24754 8.95434 -7.44407 0.420275 -322 1 11.481 10.7372 1.49136 -12.2308 11.5287 -6.19882 -323 2 11.6479 11.6347 1.11375 -3.03535 -20.3842 8.82813 -324 2 10.5208 10.5745 1.38561 13.1816 3.92224 -1.496 -325 1 13.1382 7.21836 12.5396 -14.3564 7.08975 0.177427 -326 2 14.0771 7.12045 12.4061 13.875 -7.92794 3.07029 -327 2 12.7619 6.3345 12.5945 1.25366 -4.42296 3.81153 -328 1 9.68698 1.99848 0.824055 10.3256 0.727137 24.2023 -329 2 8.81917 1.78721 0.50968 -15.0497 -1.62599 -5.65 -330 2 10.155 2.38703 0.0980655 8.32187 5.69202 -13.7925 -331 1 10.602 13.3929 4.55586 17.4753 0.473987 25.0493 -332 2 11.4671 12.9458 4.66597 -13.9744 4.33191 -5.6004 -333 2 10.4831 13.8198 5.42698 -1.33045 -1.26907 -13.5894 -334 1 14.5505 1.55995 10.9504 0.793491 3.39408 -6.18689 -335 2 15.3506 1.17936 10.5364 -11.0229 12.1378 4.59402 -336 2 14.5582 2.53024 10.8225 7.4254 -12.0179 1.55597 -337 1 14.4508 12.0407 11.6074 10.4267 -5.99888 -36.1251 -338 2 15.2905 12.2256 11.0848 -31.5625 -1.98982 15.431 -339 2 13.8033 11.6041 10.9773 26.0423 16.8772 21.3357 -340 1 8.16091 5.15464 9.81808 -31.1733 -3.04727 19.1057 -341 2 7.28259 5.21015 10.2725 23.9466 4.77499 -10.0641 -342 2 8.23945 4.21356 9.63446 4.25293 -1.90524 -4.29988 -343 1 1.57078 16.9857 18.5145 2.11582 4.65495 -1.34384 -344 2 1.81738 17.3492 17.6562 0.32294 -2.46744 1.69741 -345 2 1.87051 16.0745 18.5076 0.982883 -4.60963 -1.80737 -346 1 1.40224 17.4231 15.3612 30.835 -28.8708 -16.9337 -347 2 1.58171 18.2262 15.8024 1.01568 35.607 16.5514 -348 2 0.474852 17.284 15.3634 -28.8421 -6.17683 0.802216 -349 1 3.44554 5.70547 6.04619 4.62282 22.475 -0.524537 -350 2 3.1428 6.44974 6.61309 0.90031 -17.6364 -10.4242 -351 2 4.06586 6.09018 5.39907 -5.11167 -0.757253 7.03456 -352 1 12.635 9.5385 14.2471 10.4135 -57.691 -2.75625 -353 2 13.0561 8.75521 13.7543 -17.7171 41.3381 15.7803 -354 2 12.3533 9.10151 15.082 0.88858 17.3566 -13.7461 -355 1 4.11217 15.1814 7.19429 24.0597 14.9458 -6.20919 -356 2 3.65166 15.9525 6.80506 8.00815 -8.18076 7.53786 -357 2 5.09537 15.3539 7.08579 -34.9804 -3.92885 1.78443 -358 1 0.830872 8.84313 15.1657 1.50937 4.0339 -6.81168 -359 2 0.547306 9.77972 15.0966 9.11455 -14.6477 -1.64448 -360 2 1.6109 8.72602 14.589 -11.0561 6.95599 3.23137 -361 1 12.8981 8.26079 10.0923 10.5692 -21.7103 -4.02448 -362 2 13.6229 7.70102 9.77244 -0.136865 10.7899 -7.02632 -363 2 12.7945 7.93077 10.9815 -6.52785 3.68747 11.7154 -364 1 15.1981 8.09018 3.38532 -13.0459 -52.6521 2.11346 -365 2 14.5247 7.61376 2.86907 3.36606 26.685 -8.7616 -366 2 15.3386 7.39586 4.05885 15.5852 26.7124 4.01456 -367 1 17.1365 6.7605 0.0284285 -19.4133 2.32297 -2.08842 -368 2 16.6422 5.96523 0.300426 11.1165 9.80228 -2.81184 -369 2 16.4267 7.37993 18.3943 16.5678 -7.00446 5.84521 -370 1 8.97527 7.00353 7.90402 -12.8517 -1.3564 7.9131 -371 2 9.8962 7.25242 7.83012 8.98921 2.98997 4.36252 -372 2 8.82463 6.62979 8.79874 5.5237 0.780274 -18.1173 -373 1 12.5342 0.599732 1.22272 7.37234 -11.2249 5.10795 -374 2 13.3221 0.863275 1.71742 -3.27048 6.46822 -3.34517 -375 2 12.885 0.18837 0.429335 -4.8121 3.35952 -2.50919 -376 1 5.70486 15.0289 14.4325 -10.0966 26.0987 -8.04315 -377 2 4.75654 15.1126 14.6498 8.83064 -2.51751 -1.0487 -378 2 5.99172 15.9344 14.1552 -2.67099 -19.6319 8.34541 -379 1 3.68772 6.51886 1.67786 -9.02664 17.532 -4.1283 -380 2 3.3123 7.35563 1.32777 6.95322 -18.4916 -0.718273 -381 2 3.69933 6.70385 2.62114 4.49099 -5.2411 1.79351 -382 1 3.84119 11.2683 12.301 -11.0219 1.87445 3.30422 -383 2 4.7083 11.6207 12.5295 0.62865 1.71432 1.43021 -384 2 3.16952 11.829 12.7259 9.18863 0.324364 -2.3982 -385 1 5.33774 3.90131 15.6575 3.88008 58.1131 -0.302695 -386 2 6.0029 3.30263 15.356 18.6017 -19.7261 -0.90724 -387 2 5.77609 4.81808 15.6348 -20.8077 -39.2998 1.51453 -388 1 13.9476 10.0954 4.76119 43.1598 -13.631 -14.8551 -389 2 14.3099 9.89525 5.64952 -11.5358 -2.78357 -16.2598 -390 2 14.5437 9.62633 4.09138 -26.3956 16.5702 30.5617 -391 1 7.47949 17.2779 8.9575 1.27559 12.2273 10.3752 -392 2 6.80648 17.541 9.63427 13.3482 -0.885269 -20.4433 -393 2 7.81637 18.0666 8.4826 -8.0179 -7.75644 7.92076 -394 1 4.60365 14.3557 3.73459 -2.67085 -0.0597314 40.4087 -395 2 4.53549 15.2621 4.14744 4.43815 -28.6634 -11.7113 -396 2 4.62044 13.6529 4.46513 -1.80956 31.3212 -27.6241 -397 1 14.2431 7.29194 15.9057 25.6353 16.9765 2.1683 -398 2 15.0475 7.32515 15.3368 -17.0197 -3.00413 14.2387 -399 2 14.4656 7.87429 16.6673 -6.53416 -15.6271 -13.0076 -400 1 2.96496 18.4208 1.99119 15.7852 32.1682 20.7835 -401 2 2.67672 17.8955 1.28044 -15.5564 -27.5435 -28.9446 -402 2 2.23493 0.385121 2.17733 5.2916 -3.96739 2.45348 -403 1 7.98476 1.5873 4.50407 1.38949 2.52923 0.695279 -404 2 7.37343 2.0449 3.91068 5.19751 -1.80104 2.00097 -405 2 8.86519 1.9238 4.29038 -5.22298 -3.29695 -0.501883 -406 1 2.57117 14.1691 17.7571 1.007 -17.2424 4.53378 -407 2 1.90219 13.4698 17.9606 14.5878 19.4169 -2.4542 -408 2 3.44824 13.7555 17.8862 -10.6426 1.83574 2.42644 -409 1 1.00451 2.03285 13.8784 10.3502 2.39599 -10.3714 -410 2 1.16144 1.84563 14.7992 2.97823 -2.88805 14.0985 -411 2 0.0700994 1.90667 13.7535 -13.5508 1.82952 -2.05389 -412 1 4.33902 0.200757 13.8843 13.0721 -10.005 -1.30306 -413 2 5.22858 18.4296 13.858 -15.0619 9.43809 1.75921 -414 2 3.93054 18.5168 14.6942 4.28146 4.19272 1.73225 -415 1 7.39543 1.05973 18.4904 -6.66444 -3.84456 4.72925 -416 2 7.66739 0.634389 17.6825 2.48525 -3.87431 -15.5197 -417 2 6.44311 1.20989 18.4324 3.08246 -0.882049 5.31666 -418 1 15.7652 18.4035 13.928 -3.86344 6.1861 11.5309 -419 2 14.8535 18.6979 13.7607 9.26883 -6.83338 6.65234 -420 2 15.8985 -0.310566 14.8997 -7.7909 7.80446 -17.2978 -421 1 10.2952 4.64795 16.1844 -42.7729 -17.7833 -2.18791 -422 2 11.2045 4.84382 16.2798 37.5776 1.06228 1.58962 -423 2 10.2217 3.67206 16.1998 1.46017 15.0252 -2.22652 -424 1 15.8927 17.6472 4.46477 -15.4234 23.5431 17.5975 -425 2 16.4754 18.4255 4.65687 -16.3789 -18.5079 -6.3799 -426 2 14.9773 17.9018 4.78742 33.6258 -6.52099 -13.8394 -427 1 6.90155 17.6195 13.966 46.0362 -18.082 7.69792 -428 2 7.5054 17.5909 14.7751 -24.8486 6.04139 -28.3759 -429 2 7.50943 17.3755 13.214 -16.8133 11.713 21.5591 -430 1 13.2082 6.37265 6.52765 -13.548 -6.29238 7.5029 -431 2 14.0171 6.83631 6.34759 17.8515 4.0742 0.884882 -432 2 12.7912 6.26458 5.66961 -1.80962 -1.49443 -3.94736 -433 1 7.85263 2.26509 9.52735 -7.99894 -5.84405 -22.7054 -434 2 7.25184 2.06178 10.2504 -3.996 2.15095 3.09306 -435 2 7.39499 1.97805 8.69805 10.2818 7.88442 20.3126 -436 1 15.1135 14.8377 13.7906 -14.0873 7.85215 4.54273 -437 2 14.8065 15.1503 14.6696 4.89633 -5.66092 -15.9193 -438 2 14.526 15.2486 13.1323 8.68819 -2.70507 8.56313 -439 1 9.34389 8.42481 3.82801 17.2784 -12.6228 -3.36469 -440 2 10.2481 8.71643 4.0808 -19.781 -0.493733 -4.13474 -441 2 9.39514 7.45876 3.71283 -1.01674 10.6173 4.41109 -442 1 17.6406 13.5721 16.5094 2.04355 14.6677 -13.2606 -443 2 16.6957 13.3564 16.5004 3.03121 5.86868 -4.35941 -444 2 17.7908 14.3862 15.9732 -9.46726 -16.3028 8.56732 -445 1 4.98477 10.3524 2.78056 12.7386 5.36526 19.5004 -446 2 5.77841 9.87677 3.08402 -8.11584 2.70387 -5.95057 -447 2 4.78102 10.9105 3.55814 -3.18863 -4.34789 -14.1468 -448 1 3.61985 8.409 9.90418 -6.90754 6.83907 7.996 -449 2 3.65115 9.35813 9.71914 3.08439 -3.40065 -3.71786 -450 2 3.2182 8.36489 10.7858 3.70965 -2.47637 -5.74153 -451 1 15.9601 6.9243 5.80742 5.84252 7.06727 3.15212 -452 2 16.6786 7.33659 6.3256 -10.6597 -9.43019 -8.8571 -453 2 16.2068 5.99858 5.66915 1.21675 5.97088 2.68601 -454 1 15.2845 7.30815 8.96614 12.789 49.367 -12.5087 -455 2 15.9618 7.62249 9.60336 -10.429 -10.3168 -7.48119 -456 2 15.189 8.09577 8.33246 -3.07462 -40.144 23.8491 -457 1 6.1828 12.7537 12.7561 7.28509 13.2747 4.63662 -458 2 7.05451 12.4627 13.0861 -13.4204 -0.208789 -0.140696 -459 2 5.95622 13.5898 13.2147 8.13015 -13.1574 -2.88232 -460 1 12.1263 4.55994 13.1396 29.7192 24.8274 2.05513 -461 2 12.1786 4.68706 14.0984 -0.0287765 -3.56256 -2.83377 -462 2 11.367 4.05454 12.9285 -29.3831 -17.3036 -0.987503 -463 1 11.4694 8.07241 7.80966 2.82892 -5.30182 3.11258 -464 2 12.1089 7.42736 7.43222 -7.16455 14.3649 9.80055 -465 2 11.7078 8.26067 8.74179 3.19872 -8.99269 -16.594 -466 1 16.9463 10.7531 7.60486 21.0922 -19.3927 -30.7185 -467 2 17.5464 10.0071 7.31859 -16.0594 21.8542 15.0855 -468 2 16.9098 11.3402 6.82058 -3.06841 -4.58473 14.7168 -469 1 5.28146 18.0409 10.6472 -25.9515 -7.83546 -6.26387 -470 2 4.85268 17.2439 11.0337 11.609 18.382 -10.1496 -471 2 4.62194 18.3715 9.98111 20.3861 -11.8767 18.8687 -472 1 7.65293 17.466 1.56177 -3.43219 -2.17163 16.4468 -473 2 8.27069 16.8213 1.23778 3.23069 -17.6415 -5.16563 -474 2 7.58305 18.0963 0.859771 -3.72786 20.9018 -9.77855 -475 1 1.92587 12.9087 13.6164 -8.16731 5.11551 18.4441 -476 2 1.30634 12.3949 14.1755 13.4846 7.44573 -7.00244 -477 2 2.13079 13.7319 14.1159 -1.95883 -16.9131 -9.84331 -478 1 9.29336 6.75339 14.7687 -19.1125 21.7104 1.76678 -479 2 9.711 5.9819 15.1082 15.9481 -24.452 8.13362 -480 2 9.58853 6.88119 13.8676 2.75751 0.822828 -8.36077 -481 1 15.2452 4.28737 10.7623 -0.225576 -4.08648 -1.74219 -482 2 16.1503 3.99339 10.8719 6.1947 -5.72264 -8.71474 -483 2 15.1717 4.92602 11.4736 -7.0877 3.5816 0.665059 -484 1 11.4391 6.24473 0.0517087 -15.4849 -28.4826 -7.88372 -485 2 11.5335 5.29025 18.4586 5.11122 21.8085 5.83846 -486 2 10.469 6.36117 18.7264 13.3105 4.99187 -1.92993 -487 1 18.4571 11.4845 14.9094 -8.14212 27.2991 -26.8701 -488 2 18.0442 12.0056 14.1458 10.7134 -26.1217 30.6713 -489 2 18.3691 12.0954 15.6567 -1.55188 -2.54901 -1.51407 -490 1 7.07006 9.2713 7.35429 3.52198 -23.4346 -4.90088 -491 2 6.57918 8.46088 7.59869 6.01934 15.522 -0.341791 -492 2 7.98054 8.95273 7.2441 -4.91945 6.78887 2.19469 -493 1 18.4213 15.3485 12.1512 14.6289 14.7183 -5.00343 -494 2 0.703338 15.6554 12.0361 -12.928 -5.55139 4.18882 -495 2 17.8805 15.9633 11.6295 -1.60931 -6.92771 2.64168 -496 1 16.5853 4.3259 5.32941 -3.23822 -14.2219 46.7572 -497 2 16.614 4.15863 6.32722 1.43031 7.89007 -40.0485 -498 2 17.5031 4.43236 5.0545 -4.12857 4.88068 -4.00684 -499 1 17.7656 3.15988 10.7489 -7.77815 -3.54726 5.22618 -500 2 18.6517 3.33727 11.1036 -6.02481 -6.41431 -8.69585 -501 2 17.7347 2.25304 10.4054 5.10772 5.83768 0.491016 -502 1 12.3532 18.6195 10.0845 2.26138 29.9542 0.82462 -503 2 11.4554 0.369133 10.2956 34.814 -7.7062 -6.49387 -504 2 13.0539 0.703372 10.1287 -31.4455 -25.8056 2.12568 -505 1 10.4062 9.7592 12.5463 4.94309 9.48659 9.1975 -506 2 11.1178 9.86775 13.2051 -4.84217 -3.21907 -8.75193 -507 2 10.4169 8.83 12.3092 -0.242296 -5.43122 1.67162 -508 1 0.754807 2.57366 7.2759 5.10959 9.37805 -1.17349 -509 2 1.15147 3.40426 7.59563 -2.53061 -11.14 3.70439 -510 2 0.94825 1.90755 7.95351 -0.370046 8.4477 -4.76995 -511 1 0.326852 15.3245 6.92393 7.78779 -47.7914 -15.9381 -512 2 0.478367 15.1955 7.87742 -3.54148 6.5065 -12.4551 -513 2 0.511792 14.4078 6.50445 -6.22026 47.2618 21.2659 -514 1 17.0448 6.87527 14.9011 7.50868 -3.64469 2.18783 -515 2 17.7829 7.50382 14.839 -4.82102 -5.02166 1.59119 -516 2 17.384 6.09018 15.3732 -3.19441 8.7454 -5.86774 -517 1 9.10521 12.4991 8.01627 -22.444 -7.37457 -9.07321 -518 2 9.5155 11.7197 7.59468 -6.97176 5.64777 -5.01838 -519 2 8.17012 12.5725 7.67989 31.3303 -7.17656 9.91942 -520 1 1.12679 1.65794 2.79756 -4.95635 8.46302 6.6874 -521 2 0.642552 2.15227 2.11219 8.6081 -1.07022 6.53976 -522 2 1.60228 2.28223 3.37541 -5.16033 -3.32404 -9.46208 -523 1 4.24509 15.0269 10.0531 -9.28044 4.63084 -2.70058 -524 2 3.93721 15.2031 9.15401 2.26907 2.00751 2.33164 -525 2 5.07496 14.5648 9.92961 6.13338 0.348707 3.17177 -526 1 7.39613 2.22212 14.8791 -10.1428 -2.73186 -2.62368 -527 2 7.12857 1.59843 14.1951 -0.211704 -1.85534 3.14611 -528 2 7.6308 3.01777 14.3992 6.19568 3.75469 -5.36272 -529 1 18.3005 14.5161 2.14907 5.30067 -9.26209 1.4902 -530 2 0.506128 14.8057 2.49377 4.6744 -0.083839 -4.04908 -531 2 17.8019 15.308 1.97101 -9.85855 11.1774 -0.48774 -532 1 10.0782 2.71092 12.8944 3.88974 -3.73664 -2.78909 -533 2 9.88925 2.05355 12.2072 4.3936 3.86452 2.74403 -534 2 9.31937 3.3006 12.9074 -3.94823 0.261307 -1.05017 -535 1 2.9306 8.79131 12.9512 -25.6961 -20.8645 -0.44372 -536 2 3.33593 9.62792 12.788 10.417 21.0465 -4.83397 -537 2 3.64632 8.1716 13.058 11.1871 -7.80414 6.67576 -538 1 3.17851 8.59155 3.78391 36.0219 9.48042 20.5594 -539 2 3.64638 9.17092 3.16182 -4.0064 -4.18597 2.27442 -540 2 3.67104 8.74964 4.63715 -24.9674 -6.25544 -24.3579 -541 1 5.79667 7.27872 8.61723 -5.158 -8.45889 2.36629 -542 2 5.76122 6.32524 8.453 -1.10357 3.40671 2.32671 -543 2 5.00318 7.4879 9.12925 4.38374 0.567505 0.838777 -544 1 14.9116 1.65307 1.84567 7.03031 -5.18946 -10.6018 -545 2 15.1062 2.45757 2.3139 -4.94852 6.93451 15.0643 -546 2 15.1691 1.84916 0.935056 -0.310542 -6.30296 3.0909 -547 1 8.67523 15.0369 0.613894 1.37845 1.1536 3.61737 -548 2 9.43682 15.0729 1.21213 -3.42809 -6.51916 3.89646 -549 2 8.00447 14.4711 1.03609 4.49017 7.63347 -1.72767 -550 1 15.3993 1.47022 7.19229 -20.8703 -2.58026 0.276614 -551 2 14.6837 0.967989 6.72584 19.4319 15.0033 11.4079 -552 2 14.9834 2.26826 7.5843 2.60239 -12.333 -11.18 -553 1 4.89704 12.855 18.4725 17.7474 3.66438 12.0852 -554 2 5.22521 13.0209 0.739851 -5.30909 -3.44768 -15.7686 -555 2 5.64886 13.1114 17.9131 -8.88833 1.88365 4.35483 -556 1 15.3966 8.71526 18.0579 -0.0737912 10.217 -6.92241 -557 2 15.7913 9.20885 17.3059 -4.72516 -6.1114 19.2356 -558 2 15.2466 9.35419 0.13361 -0.210218 -4.05252 -7.18588 -559 1 11.9654 3.16879 18.3684 -1.96391 -6.33771 9.57431 -560 2 11.8782 2.93896 0.667559 5.83177 -2.01678 -11.7343 -561 2 12.3624 2.38725 17.9444 -0.743858 8.0566 3.61175 -562 1 13.1976 12.733 5.19814 3.21154 2.81721 -3.88454 -563 2 13.6265 11.8743 5.11099 -2.80289 -1.59076 -2.45209 -564 2 13.3962 13.0406 6.08845 -1.48061 -3.43823 1.63358 -565 1 6.20234 7.07161 0.291392 8.37087 -8.50913 -15.2358 -566 2 6.21431 8.03007 18.9132 -3.08565 9.14852 3.50692 -567 2 5.28911 6.79756 0.384068 -8.05152 4.04277 7.5169 -568 1 17.755 15.8811 14.8809 -0.846783 4.67036 -1.95176 -569 2 16.8205 16.1356 14.922 6.46156 -5.25763 -8.70949 -570 2 17.9775 15.7319 13.9423 -7.01069 1.37948 9.8425 -571 1 13.0816 0.927432 16.7559 7.19813 -13.1533 1.9849 -572 2 14.0246 0.654652 16.7787 -14.5584 8.9122 1.46691 -573 2 12.5958 0.0867106 16.6751 4.09548 8.26383 -2.86333 -574 1 10.8721 14.5032 7.42074 17.8947 27.9436 -17.0444 -575 2 10.196 13.9242 7.71676 -22.829 -18.2345 11.9548 -576 2 11.6972 14.0514 7.58445 7.42519 -9.80791 -0.577526 -577 1 17.7647 8.42346 2.16939 -4.1598 1.60766 -5.89387 -578 2 16.8709 8.3975 2.49669 -12.234 5.23478 11.868 -579 2 17.7295 7.75318 1.48744 5.54579 -3.65645 -10.0136 -580 1 12.5773 7.79072 2.0332 1.0668 2.49746 -6.2566 -581 2 12.3914 8.73063 1.87761 -0.101344 -7.79782 -0.82295 -582 2 12.2276 7.2965 1.27263 1.31444 5.98607 5.5368 -583 1 12.0208 14.4615 10.4933 -27.7219 6.00234 -17.9899 -584 2 12.3406 14.2687 9.58404 -10.0812 4.98999 20.4987 -585 2 11.0483 14.7039 10.4238 33.6221 -8.97773 -1.58279 -586 1 6.69486 6.68845 15.5484 18.1135 9.98152 11.3143 -587 2 7.65688 6.85274 15.3559 -27.8703 -4.06425 5.81014 -588 2 6.48582 7.17335 16.3722 6.10572 -10.2019 -13.6564 -589 1 7.96659 4.39718 13.2272 4.51058 -7.9075 4.77481 -590 2 7.2893 4.70584 12.6248 -6.54048 3.46732 -4.14994 -591 2 8.21018 5.15068 13.7582 2.30488 10.1178 3.17748 -592 1 13.2671 12.2369 14.4347 -4.64765 -4.51239 1.04229 -593 2 13.0608 11.2949 14.304 4.07546 7.63325 0.952283 -594 2 13.624 12.5445 13.5893 -0.484314 -1.81518 4.66288 -595 1 14.4631 9.64208 7.37348 -3.22195 -17.9745 -8.46037 -596 2 15.2455 10.1455 7.54143 19.6931 12.3162 5.07411 -597 2 13.7594 10.075 7.84063 -11.2512 5.66435 9.63044 -598 1 12.6955 16.8004 3.38503 4.61351 40.5798 -15.2407 -599 2 12.79 17.4151 4.16128 -2.51333 -18.5745 -25.4999 -600 2 12.6728 17.373 2.55111 0.0132769 -17.6878 38.2975 -601 1 0.968812 6.96727 17.3326 -17.527 29.8281 -14.7856 -602 2 0.0966102 7.11435 17.7475 9.38145 -12.9539 -1.45746 -603 2 0.942675 7.56475 16.5473 6.51552 -11.7527 16.88 -604 1 12.9918 4.86088 15.7598 14.9884 1.53364 0.213735 -605 2 13.6417 4.12341 15.6561 -13.2544 27.5281 4.62454 -606 2 13.5036 5.69571 15.8607 -8.5455 -17.4296 -3.38108 -607 1 2.31456 3.41181 5.02375 -16.8072 14.5355 28.5245 -608 2 1.72499 3.01856 5.74541 26.0591 16.5367 -23.5498 -609 2 2.61813 4.33638 5.31016 -13.7452 -42.3935 -5.38282 -610 1 8.12877 10.8743 13.7813 26.8177 -26.1009 35.9685 -611 2 8.08888 10.4248 14.7095 5.12746 27.8083 -58.2879 -612 2 8.93477 10.511 13.3312 -19.2021 7.65314 13.0743 -613 1 13.0038 1.57226 13.2324 0.46489 2.31008 -10.6366 -614 2 13.6096 1.43937 12.4592 -18.9356 10.6634 16.2552 -615 2 12.412 2.34128 13.062 19.3329 -16.3736 -0.813643 -616 1 6.65189 13.7072 1.97939 -2.77776 -1.20266 13.9341 -617 2 6.01392 14.2112 2.53362 13.0928 -13.1372 -7.18637 -618 2 7.15166 13.1216 2.589 -8.8324 11.1791 -7.86511 -619 1 15.7768 6.33135 12.4394 -16.9523 -8.61752 -2.39927 -620 2 16.2545 6.83373 11.7966 11.5481 11.8457 -13.8092 -621 2 16.2346 6.49819 13.2509 8.584 1.06891 20.063 -622 1 16.7487 0.656157 9.53186 -1.89022 -32.3669 -10.6998 -623 2 16.6929 18.3191 9.69193 -1.14735 24.5709 0.588436 -624 2 16.3744 0.798362 8.64008 0.39513 1.76057 8.35052 -625 1 6.2256 11.6996 8.23382 -7.45249 -33.5883 4.29961 -626 2 5.41287 11.5766 8.79278 22.02 -5.73867 -21.2662 -627 2 6.53136 10.7979 7.88958 -15.1732 37.063 20.6987 -628 1 2.75779 8.608 0.340468 -48.3199 -4.33351 -7.97969 -629 2 2.08546 8.0585 18.4464 30.1073 27.602 24.3697 -630 2 2.23564 9.25518 0.892435 12.8354 -18.7139 -20.5564 -631 1 10.0773 10.2182 6.62419 2.67327 1.92209 4.62159 -632 2 10.5668 9.53044 7.10449 -1.07652 4.95909 -5.68289 -633 2 10.5655 10.3766 5.79827 -6.62323 -4.53969 7.46345 -634 1 6.84859 15.7294 6.8116 4.5172 -4.61086 -5.81045 -635 2 7.14728 16.2498 7.57791 -4.63192 -2.64256 -11.095 -636 2 7.17659 16.1616 6.00258 -4.95191 3.23702 9.76552 -637 1 6.62071 12.9207 5.93401 2.33655 2.8557 1.84805 -638 2 6.83452 13.8255 6.17261 -0.629609 6.79635 0.913528 -639 2 6.25462 12.5309 6.73716 -1.14115 0.401949 -5.14594 -640 1 16.7089 12.5339 9.77339 -0.869689 -1.39856 -8.71911 -641 2 16.7622 11.7819 9.15626 3.31473 10.0385 4.47785 -642 2 17.1611 13.2788 9.34464 -3.7572 -10.2702 6.17681 -643 1 6.29845 2.79213 2.75928 -3.20566 -14.4941 8.67087 -644 2 6.41489 3.68807 2.47435 5.42045 18.7619 -3.24562 -645 2 5.94058 2.32523 2.00482 -4.41542 -3.11109 -6.82659 -646 1 10.6289 2.95834 3.25769 -6.57134 8.8614 -3.08687 -647 2 10.3824 3.87829 3.42309 -0.834706 -5.50201 2.33367 -648 2 10.1446 2.71475 2.45701 2.51779 -3.35726 0.152255 diff --git a/examples/amoeba/dump.water_dimer.amoeba.1 b/examples/amoeba/dump.water_dimer.amoeba.1 deleted file mode 100644 index ec6d3eb2cd..0000000000 --- a/examples/amoeba/dump.water_dimer.amoeba.1 +++ /dev/null @@ -1,165 +0,0 @@ -ITEM: TIMESTEP -0 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.024616 -0.001154 -0.003748 7.94661 0.0143882 11.5654 -2 2 -0.244211 -0.000666 0.933978 -7.05777 -0.00770443 -3.06431 -3 2 0.932234 -0.000406 -0.008705 -0.956334 -0.00629552 -7.87238 -4 1 -0.892721 0.00012 2.77367 -12.7377 -0.00815373 2.78728 -5 2 -1.463 0.75512 2.93387 6.39935 4.06267 -1.71086 -6 2 -1.46181 -0.755549 2.93493 6.40581 -4.05491 -1.70517 -ITEM: TIMESTEP -10 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0210901 -0.00114727 0.00187855 -6.1441 -0.00926688 -6.30688 -2 2 -0.299755 -0.000716119 0.924842 7.69349 0.00623407 0.274054 -3 2 0.933941 -0.000453269 -0.0777281 -1.08824 0.00357639 6.29137 -4 1 -0.89902 0.000115499 2.77431 8.40057 0.0041921 -3.3195 -5 2 -1.41411 0.797948 2.92323 -4.42685 -5.12343 1.53409 -6 2 -1.41285 -0.798315 2.92435 -4.43485 5.1187 1.52687 -ITEM: TIMESTEP -20 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0253162 -0.0011519 9.30621e-06 6.65721 0.0114207 8.7962 -2 2 -0.214112 -0.000636438 0.94263 -7.71284 -0.00678668 -1.03908 -3 2 0.928921 -0.000430955 -0.0404651 0.717191 -0.00462784 -7.37266 -4 1 -0.894334 0.00011596 2.76974 -10.0965 -0.00568803 3.16137 -5 2 -1.45804 0.75449 2.94684 5.21348 5.11475 -1.77652 -6 2 -1.45685 -0.754893 2.9479 5.22149 -5.10907 -1.76931 -ITEM: TIMESTEP -30 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0221554 -0.0011439 0.00783939 -8.36895 -0.0130834 -9.24354 -2 2 -0.25261 -0.000667783 0.941075 6.36112 0.00692164 2.73081 -3 2 0.92432 -0.000494304 -0.125343 2.07038 0.00615069 6.42537 -4 1 -0.900866 0.00010992 2.76846 11.0986 0.00640696 -3.42785 -5 2 -1.40977 0.795072 2.93807 -5.57817 -3.04583 1.75974 -6 2 -1.40852 -0.795411 2.93919 -5.58301 3.03943 1.75548 -ITEM: TIMESTEP -40 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0269208 -0.00114842 0.00674288 5.42877 0.00730481 4.31748 -2 2 -0.171607 -0.000594964 0.954009 -8.40692 -0.00484075 2.50346 -3 2 0.92209 -0.000466908 -0.0840066 2.3456 -0.00296432 -6.82561 -4 1 -0.895716 0.000110956 2.76419 -6.18264 -0.00259137 3.07323 -5 2 -1.45218 0.754436 2.95353 3.40261 6.39649 -1.53879 -6 2 -1.45099 -0.75482 2.9546 3.41259 -6.3934 -1.52976 -ITEM: TIMESTEP -50 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0239329 -0.00114175 0.0128926 -8.15007 -0.014184 -11.0504 -2 2 -0.230937 -0.000644481 0.949766 5.72493 0.00756591 4.36142 -3 2 0.91871 -0.000511822 -0.144074 2.40885 0.00639366 6.3907 -4 1 -0.899724 0.000108594 2.76531 11.5106 0.00694105 -3.03119 -5 2 -1.41275 0.792848 2.92798 -5.74551 -2.08247 1.6662 -6 2 -1.41151 -0.793206 2.9291 -5.7488 2.07576 1.66327 -ITEM: TIMESTEP -60 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0287434 -0.0011479 0.00953424 6.82379 0.00862743 4.63675 -2 2 -0.180318 -0.000600308 0.956082 -8.03241 -0.00482631 2.10983 -3 2 0.922397 -0.000459471 -0.0739414 0.782565 -0.00412295 -6.72684 -4 1 -0.892694 0.000113827 2.76489 -6.55004 -0.00361317 2.26756 -5 2 -1.45749 0.757284 2.91975 3.48398 5.14308 -1.14726 -6 2 -1.4563 -0.757724 2.92081 3.49211 -5.13915 -1.14003 -ITEM: TIMESTEP -70 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.025848 -0.00114271 0.0136758 -6.10179 -0.0106002 -8.24377 -2 2 -0.259382 -0.000669072 0.94681 6.59121 0.0065405 1.93161 -3 2 0.923692 -0.000484045 -0.110366 -0.0484081 0.00428029 6.1322 -4 1 -0.894893 0.000114175 2.76783 7.43985 0.00424265 -2.1131 -5 2 -1.42416 0.79251 2.88639 -3.9377 -3.53776 1.14903 -6 2 -1.42292 -0.792944 2.88751 -3.94318 3.53329 1.14403 -ITEM: TIMESTEP -80 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.030135 -0.00114891 0.00965506 7.41429 0.0123912 9.3266 -2 2 -0.213346 -0.000627628 0.954378 -6.76672 -0.00675668 -2.04974 -3 2 0.924938 -0.000432456 -0.0385785 -0.591495 -0.00546702 -7.10385 -4 1 -0.888796 0.000119275 2.76827 -9.03539 -0.00642914 1.05959 -5 2 -1.46214 0.762697 2.87512 4.48797 2.10983 -0.617778 -6 2 -1.46094 -0.763208 2.87619 4.49133 -2.10357 -0.61482 -ITEM: TIMESTEP -90 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0270206 -0.00114299 0.0145983 -6.11813 -0.00811207 -4.69194 -2 2 -0.274281 -0.000680382 0.947366 7.50569 0.00503125 -1.23144 -3 2 0.92514 -0.000469353 -0.0912836 -0.650877 0.00352314 5.72916 -4 1 -0.891964 0.000116952 2.76852 3.17186 0.0014363 -1.52231 -5 2 -1.43137 0.791127 2.86377 -1.95059 -4.67792 0.861555 -6 2 -1.43013 -0.791605 2.86488 -1.95795 4.67604 0.85497 -ITEM: TIMESTEP -100 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.030669 -0.00114759 0.0121427 6.42493 0.0120997 10.0073 -2 2 -0.203569 -0.000615753 0.960107 -6.40597 -0.00736639 -3.30674 -3 2 0.923036 -0.000442107 -0.0503324 -0.0528607 -0.00477186 -6.71539 -4 1 -0.889443 0.000116814 2.76553 -7.7691 -0.0050422 1.37075 -5 2 -1.45671 0.76736 2.88018 3.9012 0.426437 -0.678284 -6 2 -1.4555 -0.767854 2.88126 3.9018 -0.421357 -0.677675 diff --git a/examples/amoeba/dump.water_dimer.amoeba.4 b/examples/amoeba/dump.water_dimer.amoeba.4 deleted file mode 100644 index ec6d3eb2cd..0000000000 --- a/examples/amoeba/dump.water_dimer.amoeba.4 +++ /dev/null @@ -1,165 +0,0 @@ -ITEM: TIMESTEP -0 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.024616 -0.001154 -0.003748 7.94661 0.0143882 11.5654 -2 2 -0.244211 -0.000666 0.933978 -7.05777 -0.00770443 -3.06431 -3 2 0.932234 -0.000406 -0.008705 -0.956334 -0.00629552 -7.87238 -4 1 -0.892721 0.00012 2.77367 -12.7377 -0.00815373 2.78728 -5 2 -1.463 0.75512 2.93387 6.39935 4.06267 -1.71086 -6 2 -1.46181 -0.755549 2.93493 6.40581 -4.05491 -1.70517 -ITEM: TIMESTEP -10 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0210901 -0.00114727 0.00187855 -6.1441 -0.00926688 -6.30688 -2 2 -0.299755 -0.000716119 0.924842 7.69349 0.00623407 0.274054 -3 2 0.933941 -0.000453269 -0.0777281 -1.08824 0.00357639 6.29137 -4 1 -0.89902 0.000115499 2.77431 8.40057 0.0041921 -3.3195 -5 2 -1.41411 0.797948 2.92323 -4.42685 -5.12343 1.53409 -6 2 -1.41285 -0.798315 2.92435 -4.43485 5.1187 1.52687 -ITEM: TIMESTEP -20 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0253162 -0.0011519 9.30621e-06 6.65721 0.0114207 8.7962 -2 2 -0.214112 -0.000636438 0.94263 -7.71284 -0.00678668 -1.03908 -3 2 0.928921 -0.000430955 -0.0404651 0.717191 -0.00462784 -7.37266 -4 1 -0.894334 0.00011596 2.76974 -10.0965 -0.00568803 3.16137 -5 2 -1.45804 0.75449 2.94684 5.21348 5.11475 -1.77652 -6 2 -1.45685 -0.754893 2.9479 5.22149 -5.10907 -1.76931 -ITEM: TIMESTEP -30 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0221554 -0.0011439 0.00783939 -8.36895 -0.0130834 -9.24354 -2 2 -0.25261 -0.000667783 0.941075 6.36112 0.00692164 2.73081 -3 2 0.92432 -0.000494304 -0.125343 2.07038 0.00615069 6.42537 -4 1 -0.900866 0.00010992 2.76846 11.0986 0.00640696 -3.42785 -5 2 -1.40977 0.795072 2.93807 -5.57817 -3.04583 1.75974 -6 2 -1.40852 -0.795411 2.93919 -5.58301 3.03943 1.75548 -ITEM: TIMESTEP -40 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0269208 -0.00114842 0.00674288 5.42877 0.00730481 4.31748 -2 2 -0.171607 -0.000594964 0.954009 -8.40692 -0.00484075 2.50346 -3 2 0.92209 -0.000466908 -0.0840066 2.3456 -0.00296432 -6.82561 -4 1 -0.895716 0.000110956 2.76419 -6.18264 -0.00259137 3.07323 -5 2 -1.45218 0.754436 2.95353 3.40261 6.39649 -1.53879 -6 2 -1.45099 -0.75482 2.9546 3.41259 -6.3934 -1.52976 -ITEM: TIMESTEP -50 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0239329 -0.00114175 0.0128926 -8.15007 -0.014184 -11.0504 -2 2 -0.230937 -0.000644481 0.949766 5.72493 0.00756591 4.36142 -3 2 0.91871 -0.000511822 -0.144074 2.40885 0.00639366 6.3907 -4 1 -0.899724 0.000108594 2.76531 11.5106 0.00694105 -3.03119 -5 2 -1.41275 0.792848 2.92798 -5.74551 -2.08247 1.6662 -6 2 -1.41151 -0.793206 2.9291 -5.7488 2.07576 1.66327 -ITEM: TIMESTEP -60 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0287434 -0.0011479 0.00953424 6.82379 0.00862743 4.63675 -2 2 -0.180318 -0.000600308 0.956082 -8.03241 -0.00482631 2.10983 -3 2 0.922397 -0.000459471 -0.0739414 0.782565 -0.00412295 -6.72684 -4 1 -0.892694 0.000113827 2.76489 -6.55004 -0.00361317 2.26756 -5 2 -1.45749 0.757284 2.91975 3.48398 5.14308 -1.14726 -6 2 -1.4563 -0.757724 2.92081 3.49211 -5.13915 -1.14003 -ITEM: TIMESTEP -70 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.025848 -0.00114271 0.0136758 -6.10179 -0.0106002 -8.24377 -2 2 -0.259382 -0.000669072 0.94681 6.59121 0.0065405 1.93161 -3 2 0.923692 -0.000484045 -0.110366 -0.0484081 0.00428029 6.1322 -4 1 -0.894893 0.000114175 2.76783 7.43985 0.00424265 -2.1131 -5 2 -1.42416 0.79251 2.88639 -3.9377 -3.53776 1.14903 -6 2 -1.42292 -0.792944 2.88751 -3.94318 3.53329 1.14403 -ITEM: TIMESTEP -80 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.030135 -0.00114891 0.00965506 7.41429 0.0123912 9.3266 -2 2 -0.213346 -0.000627628 0.954378 -6.76672 -0.00675668 -2.04974 -3 2 0.924938 -0.000432456 -0.0385785 -0.591495 -0.00546702 -7.10385 -4 1 -0.888796 0.000119275 2.76827 -9.03539 -0.00642914 1.05959 -5 2 -1.46214 0.762697 2.87512 4.48797 2.10983 -0.617778 -6 2 -1.46094 -0.763208 2.87619 4.49133 -2.10357 -0.61482 -ITEM: TIMESTEP -90 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0270206 -0.00114299 0.0145983 -6.11813 -0.00811207 -4.69194 -2 2 -0.274281 -0.000680382 0.947366 7.50569 0.00503125 -1.23144 -3 2 0.92514 -0.000469353 -0.0912836 -0.650877 0.00352314 5.72916 -4 1 -0.891964 0.000116952 2.76852 3.17186 0.0014363 -1.52231 -5 2 -1.43137 0.791127 2.86377 -1.95059 -4.67792 0.861555 -6 2 -1.43013 -0.791605 2.86488 -1.95795 4.67604 0.85497 -ITEM: TIMESTEP -100 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.030669 -0.00114759 0.0121427 6.42493 0.0120997 10.0073 -2 2 -0.203569 -0.000615753 0.960107 -6.40597 -0.00736639 -3.30674 -3 2 0.923036 -0.000442107 -0.0503324 -0.0528607 -0.00477186 -6.71539 -4 1 -0.889443 0.000116814 2.76553 -7.7691 -0.0050422 1.37075 -5 2 -1.45671 0.76736 2.88018 3.9012 0.426437 -0.678284 -6 2 -1.4555 -0.767854 2.88126 3.9018 -0.421357 -0.677675 diff --git a/examples/amoeba/dump.water_dimer.hippo.1 b/examples/amoeba/dump.water_dimer.hippo.1 deleted file mode 100644 index 854055cac8..0000000000 --- a/examples/amoeba/dump.water_dimer.hippo.1 +++ /dev/null @@ -1,165 +0,0 @@ -ITEM: TIMESTEP -0 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.024616 -0.001154 -0.003748 6.77815 0.012441 10.1043 -2 2 -0.244211 -0.000666 0.933978 -6.4757 -0.0067894 -2.41462 -3 2 0.932234 -0.000406 -0.008705 -0.41382 -0.00540908 -7.21892 -4 1 -0.892721 0.00012 2.77367 -11.9286 -0.00716387 3.29032 -5 2 -1.463 0.75512 2.93387 6.01759 3.00398 -1.88265 -6 2 -1.46181 -0.755549 2.93493 6.02238 -2.99706 -1.87845 -ITEM: TIMESTEP -10 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0215682 -0.00114805 0.0012979 -6.21268 -0.00924301 -6.19628 -2 2 -0.293095 -0.000710409 0.925512 6.99875 0.0060121 0.73377 -3 2 0.933101 -0.000449223 -0.0710512 -0.501529 0.00371221 5.82975 -4 1 -0.897884 0.000116793 2.77488 7.53966 0.00410482 -2.48587 -5 2 -1.42223 0.790989 2.91963 -3.9083 -4.87571 1.06275 -6 2 -1.42099 -0.791374 2.92075 -3.91591 4.87112 1.05588 -ITEM: TIMESTEP -20 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0258564 -0.00115245 -0.000173159 6.03126 0.0103631 7.9915 -2 2 -0.214264 -0.000636469 0.942735 -7.00136 -0.00592601 -0.60904 -3 2 0.929001 -0.000430037 -0.0392653 0.701856 -0.0043552 -6.96821 -4 1 -0.893054 0.000118973 2.77259 -8.83712 -0.00512625 2.54445 -5 2 -1.46387 0.753541 2.92502 4.54888 4.85296 -1.48277 -6 2 -1.46268 -0.753984 2.92608 4.55648 -4.84791 -1.47593 -ITEM: TIMESTEP -30 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0237238 -0.00114526 0.00766999 -7.81865 -0.0119879 -8.3015 -2 2 -0.241061 -0.000656856 0.943727 6.09288 0.0066852 2.69388 -3 2 0.923032 -0.000493736 -0.123121 1.75879 0.00552582 5.88556 -4 1 -0.897978 0.000115451 2.77309 11.6501 0.00727223 -2.82116 -5 2 -1.42536 0.788259 2.90023 -5.83991 -2.07218 1.27305 -6 2 -1.42412 -0.788676 2.90134 -5.84324 2.06468 1.27016 -ITEM: TIMESTEP -40 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0292005 -0.00114894 0.00855106 5.6712 0.00787804 4.86214 -2 2 -0.153199 -0.000576377 0.959922 -7.58451 -0.00449199 2.07976 -3 2 0.919336 -0.000480028 -0.0995905 1.37912 -0.00359093 -6.63778 -4 1 -0.89217 0.000118771 2.77132 -5.68638 -0.00321013 1.64962 -5 2 -1.47004 0.751887 2.88738 3.10503 6.73714 -0.981624 -6 2 -1.46886 -0.752392 2.88844 3.11554 -6.73373 -0.972121 -ITEM: TIMESTEP -50 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0276682 -0.00114169 0.0171537 -7.90829 -0.012452 -8.85967 -2 2 -0.185755 -0.000598779 0.964286 5.83022 0.00671605 3.0354 -3 2 0.908646 -0.000541992 -0.175729 1.96931 0.00577867 6.00768 -4 1 -0.895573 0.00011689 2.77245 11.8261 0.00822001 -1.54401 -5 2 -1.4336 0.787999 2.84603 -5.85703 -2.08185 0.681764 -6 2 -1.43237 -0.788505 2.84714 -5.86031 2.07358 0.678838 -ITEM: TIMESTEP -60 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0340777 -0.00114581 0.0184647 7.2272 0.00951667 5.4479 -2 2 -0.113434 -0.000533921 0.975674 -7.44659 -0.00496006 1.26816 -3 2 0.909471 -0.000512535 -0.134923 -0.287426 -0.00476073 -6.43846 -4 1 -0.888126 0.000122907 2.77269 -9.08281 -0.00670232 0.725333 -5 2 -1.47838 0.753365 2.8077 4.79099 4.82306 -0.504859 -6 2 -1.47719 -0.753996 2.80876 4.79863 -4.81616 -0.498076 -ITEM: TIMESTEP -70 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0329631 -0.00113896 0.0269437 -6.82209 -0.00981599 -6.32682 -2 2 -0.16378 -0.000570078 0.980622 6.44654 0.00529861 0.332147 -3 2 0.899135 -0.000560623 -0.191768 0.56204 0.00474764 6.11404 -4 1 -0.890774 0.0001215 2.77364 7.6207 0.00561833 -0.364449 -5 2 -1.4359 0.790393 2.75878 -3.89983 -4.84574 0.12595 -6 2 -1.43466 -0.791026 2.7599 -3.90736 4.83989 0.11913 -ITEM: TIMESTEP -80 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0396799 -0.00114299 0.0287108 8.10782 0.0121934 8.26954 -2 2 -0.101327 -0.000514632 0.989821 -6.98655 -0.00644087 -1.35375 -3 2 0.902079 -0.000521504 -0.139604 -1.23495 -0.0056704 -6.67396 -4 1 -0.883488 0.000127321 2.77377 -12.2256 -0.0109573 -1.83848 -5 2 -1.47309 0.755263 2.71301 6.16734 2.89071 0.796293 -6 2 -1.4719 -0.756019 2.71407 6.17192 -2.87983 0.800362 -ITEM: TIMESTEP -90 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0383179 -0.00113532 0.0380883 -7.16334 -0.00889532 -4.6369 -2 2 -0.149498 -0.00054848 0.995531 6.83221 0.00448143 -1.26419 -3 2 0.889431 -0.00057205 -0.197356 0.916 0.00477871 5.76452 -4 1 -0.886952 0.000122589 2.77093 7.29365 0.00587785 0.155791 -5 2 -1.42602 0.790491 2.68716 -3.93543 -4.86013 -0.00619146 -6 2 -1.42478 -0.791209 2.68827 -3.94309 4.85389 -0.0130349 -ITEM: TIMESTEP -100 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0443853 -0.00113803 0.0410221 7.36858 0.0108291 7.15279 -2 2 -0.076648 -0.000485983 1.00287 -6.96363 -0.00585609 -0.543819 -3 2 0.890615 -0.000542732 -0.157107 -0.3904 -0.00504823 -6.73186 -4 1 -0.880834 0.000124898 2.7674 -9.13947 -0.00841726 -1.90715 -5 2 -1.46341 0.754149 2.66816 4.55895 4.52404 1.01184 -6 2 -1.46222 -0.754952 2.66922 4.56597 -4.51554 1.01819 diff --git a/examples/amoeba/dump.water_dimer.hippo.4 b/examples/amoeba/dump.water_dimer.hippo.4 deleted file mode 100644 index 854055cac8..0000000000 --- a/examples/amoeba/dump.water_dimer.hippo.4 +++ /dev/null @@ -1,165 +0,0 @@ -ITEM: TIMESTEP -0 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.024616 -0.001154 -0.003748 6.77815 0.012441 10.1043 -2 2 -0.244211 -0.000666 0.933978 -6.4757 -0.0067894 -2.41462 -3 2 0.932234 -0.000406 -0.008705 -0.41382 -0.00540908 -7.21892 -4 1 -0.892721 0.00012 2.77367 -11.9286 -0.00716387 3.29032 -5 2 -1.463 0.75512 2.93387 6.01759 3.00398 -1.88265 -6 2 -1.46181 -0.755549 2.93493 6.02238 -2.99706 -1.87845 -ITEM: TIMESTEP -10 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0215682 -0.00114805 0.0012979 -6.21268 -0.00924301 -6.19628 -2 2 -0.293095 -0.000710409 0.925512 6.99875 0.0060121 0.73377 -3 2 0.933101 -0.000449223 -0.0710512 -0.501529 0.00371221 5.82975 -4 1 -0.897884 0.000116793 2.77488 7.53966 0.00410482 -2.48587 -5 2 -1.42223 0.790989 2.91963 -3.9083 -4.87571 1.06275 -6 2 -1.42099 -0.791374 2.92075 -3.91591 4.87112 1.05588 -ITEM: TIMESTEP -20 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0258564 -0.00115245 -0.000173159 6.03126 0.0103631 7.9915 -2 2 -0.214264 -0.000636469 0.942735 -7.00136 -0.00592601 -0.60904 -3 2 0.929001 -0.000430037 -0.0392653 0.701856 -0.0043552 -6.96821 -4 1 -0.893054 0.000118973 2.77259 -8.83712 -0.00512625 2.54445 -5 2 -1.46387 0.753541 2.92502 4.54888 4.85296 -1.48277 -6 2 -1.46268 -0.753984 2.92608 4.55648 -4.84791 -1.47593 -ITEM: TIMESTEP -30 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0237238 -0.00114526 0.00766999 -7.81865 -0.0119879 -8.3015 -2 2 -0.241061 -0.000656856 0.943727 6.09288 0.0066852 2.69388 -3 2 0.923032 -0.000493736 -0.123121 1.75879 0.00552582 5.88556 -4 1 -0.897978 0.000115451 2.77309 11.6501 0.00727223 -2.82116 -5 2 -1.42536 0.788259 2.90023 -5.83991 -2.07218 1.27305 -6 2 -1.42412 -0.788676 2.90134 -5.84324 2.06468 1.27016 -ITEM: TIMESTEP -40 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0292005 -0.00114894 0.00855106 5.6712 0.00787804 4.86214 -2 2 -0.153199 -0.000576377 0.959922 -7.58451 -0.00449199 2.07976 -3 2 0.919336 -0.000480028 -0.0995905 1.37912 -0.00359093 -6.63778 -4 1 -0.89217 0.000118771 2.77132 -5.68638 -0.00321013 1.64962 -5 2 -1.47004 0.751887 2.88738 3.10503 6.73714 -0.981624 -6 2 -1.46886 -0.752392 2.88844 3.11554 -6.73373 -0.972121 -ITEM: TIMESTEP -50 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0276682 -0.00114169 0.0171537 -7.90829 -0.012452 -8.85967 -2 2 -0.185755 -0.000598779 0.964286 5.83022 0.00671605 3.0354 -3 2 0.908646 -0.000541992 -0.175729 1.96931 0.00577867 6.00768 -4 1 -0.895573 0.00011689 2.77245 11.8261 0.00822001 -1.54401 -5 2 -1.4336 0.787999 2.84603 -5.85703 -2.08185 0.681764 -6 2 -1.43237 -0.788505 2.84714 -5.86031 2.07358 0.678838 -ITEM: TIMESTEP -60 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0340777 -0.00114581 0.0184647 7.2272 0.00951667 5.4479 -2 2 -0.113434 -0.000533921 0.975674 -7.44659 -0.00496006 1.26816 -3 2 0.909471 -0.000512535 -0.134923 -0.287426 -0.00476073 -6.43846 -4 1 -0.888126 0.000122907 2.77269 -9.08281 -0.00670232 0.725333 -5 2 -1.47838 0.753365 2.8077 4.79099 4.82306 -0.504859 -6 2 -1.47719 -0.753996 2.80876 4.79863 -4.81616 -0.498076 -ITEM: TIMESTEP -70 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0329631 -0.00113896 0.0269437 -6.82209 -0.00981599 -6.32682 -2 2 -0.16378 -0.000570078 0.980622 6.44654 0.00529861 0.332147 -3 2 0.899135 -0.000560623 -0.191768 0.56204 0.00474764 6.11404 -4 1 -0.890774 0.0001215 2.77364 7.6207 0.00561833 -0.364449 -5 2 -1.4359 0.790393 2.75878 -3.89983 -4.84574 0.12595 -6 2 -1.43466 -0.791026 2.7599 -3.90736 4.83989 0.11913 -ITEM: TIMESTEP -80 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0396799 -0.00114299 0.0287108 8.10782 0.0121934 8.26954 -2 2 -0.101327 -0.000514632 0.989821 -6.98655 -0.00644087 -1.35375 -3 2 0.902079 -0.000521504 -0.139604 -1.23495 -0.0056704 -6.67396 -4 1 -0.883488 0.000127321 2.77377 -12.2256 -0.0109573 -1.83848 -5 2 -1.47309 0.755263 2.71301 6.16734 2.89071 0.796293 -6 2 -1.4719 -0.756019 2.71407 6.17192 -2.87983 0.800362 -ITEM: TIMESTEP -90 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0383179 -0.00113532 0.0380883 -7.16334 -0.00889532 -4.6369 -2 2 -0.149498 -0.00054848 0.995531 6.83221 0.00448143 -1.26419 -3 2 0.889431 -0.00057205 -0.197356 0.916 0.00477871 5.76452 -4 1 -0.886952 0.000122589 2.77093 7.29365 0.00587785 0.155791 -5 2 -1.42602 0.790491 2.68716 -3.93543 -4.86013 -0.00619146 -6 2 -1.42478 -0.791209 2.68827 -3.94309 4.85389 -0.0130349 -ITEM: TIMESTEP -100 -ITEM: NUMBER OF ATOMS -6 -ITEM: BOX BOUNDS ss ss ss --1.4632357229999999e+00 9.3247372299999998e-01 --7.5570026690000003e-01 7.5527126690000002e-01 --8.9995638999999985e-03 2.9352285639000000e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -0.0443853 -0.00113803 0.0410221 7.36858 0.0108291 7.15279 -2 2 -0.076648 -0.000485983 1.00287 -6.96363 -0.00585609 -0.543819 -3 2 0.890615 -0.000542732 -0.157107 -0.3904 -0.00504823 -6.73186 -4 1 -0.880834 0.000124898 2.7674 -9.13947 -0.00841726 -1.90715 -5 2 -1.46341 0.754149 2.66816 4.55895 4.52404 1.01184 -6 2 -1.46222 -0.754952 2.66922 4.56597 -4.51554 1.01819 diff --git a/examples/amoeba/dump.water_hexamer.amoeba.1 b/examples/amoeba/dump.water_hexamer.amoeba.1 deleted file mode 100644 index 88e888cc45..0000000000 --- a/examples/amoeba/dump.water_hexamer.amoeba.1 +++ /dev/null @@ -1,297 +0,0 @@ -ITEM: TIMESTEP -0 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.50217 -0.191359 1.43493 15.8836 -7.45837 3.84323 -2 2 -0.601054 -0.596972 1.55372 -22.9153 9.01978 -0.990133 -3 2 -2.0067 -0.422327 2.21985 1.01155 0.118537 -0.791932 -4 1 -1.74457 -0.382348 -1.30914 -6.66041 -3.92202 8.41554 -5 2 -1.88894 -0.479653 -0.347624 4.77968 3.15053 -8.64245 -6 2 -2.51683 -0.766765 -1.73377 2.90782 1.57916 -0.744558 -7 1 -0.560409 2.01783 -0.121984 -13.2194 -12.8195 1.43178 -8 2 -0.94772 1.53357 0.625228 6.08473 6.021 -1.58068 -9 2 -0.989831 1.59274 -0.877419 5.83415 5.52991 -0.337029 -10 1 0.964803 -1.16576 1.43999 12.6547 2.88136 -21.3636 -11 2 0.979557 -1.52204 0.527833 -3.6968 -1.92725 12.6575 -12 2 1.54222 -0.393692 1.34437 -3.37883 -2.73031 5.998 -13 1 0.974705 -1.4015 -1.33597 -6.12193 14.8514 -0.790538 -14 2 0.065161 -1.11895 -1.52289 4.56017 -6.05436 1.71545 -15 2 1.47071 -0.570933 -1.27771 1.31912 -7.40942 1.06098 -16 1 2.00228 1.05782 -0.124502 -10.3736 10.8414 -1.12005 -17 2 1.14164 1.53227 -0.140121 11.8812 -8.20067 0.772116 -18 2 2.67472 1.73534 -0.237995 -0.550493 -3.47117 0.466398 -ITEM: TIMESTEP -10 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.50661 -0.189383 1.4364 14.5938 -8.99605 8.72579 -2 2 -0.616993 -0.604745 1.5716 -17.7352 9.03346 -4.01613 -3 2 -2.01184 -0.421588 2.22126 -0.664878 1.39015 -2.52743 -4 1 -1.74564 -0.383429 -1.31051 0.451442 -0.432875 3.71075 -5 2 -1.85676 -0.451272 -0.342641 -1.17801 0.27861 -9.12816 -6 2 -2.51648 -0.764704 -1.74119 1.00433 0.523826 3.94489 -7 1 -0.565581 2.01415 -0.121947 -0.431671 0.816258 1.37224 -8 2 -0.923503 1.54613 0.649943 -0.836345 -0.35076 -8.91816 -9 2 -0.954982 1.61593 -0.9136 -0.398984 -1.29665 6.9827 -10 1 0.971315 -1.16462 1.43403 2.66632 -4.10463 -4.1745 -11 2 0.960388 -1.57587 0.54557 3.80791 8.56867 8.0783 -12 2 1.545 -0.38505 1.37422 -2.3984 -5.62816 -5.66197 -13 1 0.972827 -1.39712 -1.33549 -1.10638 0.442925 0.267527 -14 2 0.0526434 -1.14464 -1.51395 7.06933 2.8298 1.48943 -15 2 1.50554 -0.590868 -1.25662 -6.54392 -2.53639 -0.258333 -16 1 2.00275 1.0584 -0.124848 -7.13185 5.38221 -0.0306111 -17 2 1.13969 1.52381 -0.134074 11.7308 -4.5992 -0.113372 -18 2 2.68869 1.72277 -0.237084 -2.89819 -1.32119 0.257039 -ITEM: TIMESTEP -20 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.51649 -0.18584 1.44395 5.65501 -4.20149 4.07802 -2 2 -0.637196 -0.60535 1.5789 -10.2535 4.51311 -0.350867 -3 2 -2.05196 -0.408647 2.21473 3.52072 0.575858 -3.20585 -4 1 -1.74216 -0.383007 -1.31779 -5.65244 -1.7459 7.46957 -5 2 -1.85838 -0.422286 -0.35262 3.57624 0.698487 -5.03248 -6 2 -2.53778 -0.772973 -1.68856 2.62304 1.05785 -2.46299 -7 1 -0.568621 2.01502 -0.121788 -7.49291 -10.5083 -0.07078 -8 2 -0.953332 1.50031 0.601729 3.90339 5.1027 1.32659 -9 2 -0.948304 1.59097 -0.90055 3.2198 4.86429 -1.5712 -10 1 0.981527 -1.16776 1.43139 8.19382 2.30469 -14.0571 -11 2 0.999682 -1.57682 0.548153 -4.17545 -1.46604 7.90595 -12 2 1.55686 -0.401102 1.29785 -3.41945 -1.35828 5.31582 -13 1 0.971997 -1.39727 -1.33295 -3.50737 11.1512 0.685267 -14 2 0.0679408 -1.0929 -1.49373 1.59713 -5.72522 -0.144088 -15 2 1.47933 -0.582056 -1.22295 2.04209 -4.76253 -0.234646 -16 1 2.00557 1.05551 -0.12468 -4.4992 7.40197 -0.448564 -17 2 1.16008 1.5422 -0.129327 5.1837 -4.83397 0.46283 -18 2 2.69054 1.72007 -0.238059 -0.51465 -3.06849 0.334482 -ITEM: TIMESTEP -30 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.52872 -0.18011 1.45173 -0.933277 -2.21949 5.98424 -2 2 -0.665459 -0.602256 1.60472 0.633036 0.719099 -1.22127 -3 2 -2.07366 -0.404666 2.21589 2.60377 1.4581 -4.42661 -4 1 -1.74225 -0.382648 -1.3226 2.4731 1.57235 -0.799694 -5 2 -1.81423 -0.398932 -0.35676 -3.06045 -1.92828 -1.63228 -6 2 -2.5352 -0.77665 -1.69294 0.0233925 -0.139311 2.03217 -7 1 -0.576286 2.0073 -0.122823 5.68391 5.42307 0.543301 -8 2 -0.95235 1.50691 0.611905 -2.48677 -2.29116 -3.6455 -9 2 -0.915502 1.63076 -0.941481 -3.12923 -3.02599 2.90572 -10 1 0.998541 -1.16996 1.42191 -2.76709 -0.0175982 4.85417 -11 2 0.970261 -1.63876 0.575717 2.4618 4.28015 -0.493825 -12 2 1.54742 -0.386783 1.27666 -1.41861 -3.70889 -3.67396 -13 1 0.969317 -1.3895 -1.32829 2.03562 -5.48364 0.295138 -14 2 0.0583035 -1.11723 -1.49206 1.73159 3.49229 -0.0543931 -15 2 1.50655 -0.600283 -1.19205 -3.9925 1.94925 -1.04523 -16 1 2.00848 1.05446 -0.124132 1.88868 -1.58075 0.754117 -17 2 1.16959 1.53865 -0.11771 0.573913 1.34283 -0.58573 -18 2 2.71517 1.69464 -0.239075 -2.32089 0.157967 0.209615 -ITEM: TIMESTEP -40 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.53726 -0.175397 1.46121 -7.56641 2.45844 -0.518817 -2 2 -0.675238 -0.584022 1.60915 7.85196 -3.99237 1.67217 -3 2 -2.08862 -0.402087 2.21789 3.0617 0.39778 -2.04562 -4 1 -1.73949 -0.379604 -1.32819 -2.36016 -0.787528 -0.0315325 -5 2 -1.83346 -0.428429 -0.37056 1.90026 0.717301 4.17358 -6 2 -2.53017 -0.786871 -1.68316 0.151557 -0.108901 -3.75615 -7 1 -0.576955 2.0043 -0.124416 -0.431513 -1.54355 -1.46354 -8 2 -0.992092 1.48382 0.567817 1.09284 0.418387 6.78235 -9 2 -0.944746 1.62819 -0.925975 0.76441 1.37882 -5.22407 -10 1 1.00941 -1.17308 1.4189 -1.85973 4.64458 1.0889 -11 2 0.973659 -1.6403 0.580693 -1.69219 -4.78957 -3.29195 -12 2 1.53559 -0.396477 1.19908 0.544307 1.46508 3.63166 -13 1 0.969009 -1.38744 -1.3228 -0.275569 1.85307 -0.63583 -14 2 0.0737932 -1.09141 -1.50366 -4.66851 -2.83882 -1.16892 -15 2 1.46633 -0.576681 -1.19175 5.00795 0.70617 0.521536 -16 1 2.01183 1.05054 -0.121932 4.41526 -1.70685 -0.0836272 -17 2 1.19121 1.55327 -0.120038 -7.25224 2.19125 0.154184 -18 2 2.71636 1.68982 -0.237383 1.31607 -0.463304 0.195666 -ITEM: TIMESTEP -50 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.53986 -0.172749 1.46865 -10.3641 5.96951 -4.41562 -2 2 -0.678724 -0.568486 1.60775 14.9207 -7.13278 2.04782 -3 2 -2.07217 -0.405364 2.23045 -0.725799 -0.490948 1.77161 -4 1 -1.74113 -0.378171 -1.32957 5.99712 2.85952 -9.13842 -5 2 -1.82713 -0.447378 -0.375703 -3.89226 -1.3818 7.11516 -6 2 -2.4999 -0.790471 -1.74187 -3.02333 -1.60416 1.77146 -7 1 -0.579496 1.99691 -0.128028 9.72738 10.7655 -0.463519 -8 2 -0.97832 1.50522 0.591572 -4.4866 -5.64841 2.33138 -9 2 -0.951447 1.66071 -0.944057 -3.97244 -4.92262 -1.79974 -10 1 1.01358 -1.17192 1.41393 -6.48605 2.83151 13.495 -11 2 0.960671 -1.668 0.598799 0.887838 -3.18341 -9.75086 -12 2 1.53449 -0.394669 1.19537 2.46945 2.14925 -1.89795 -13 1 0.966791 -1.38037 -1.31946 4.73561 -12.449 -1.17286 -14 2 0.0653014 -1.12956 -1.52441 -4.76491 5.51904 -0.304595 -15 2 1.48076 -0.580834 -1.19775 0.0522693 6.36707 0.249418 -16 1 2.01309 1.04924 -0.119438 7.79557 -11.0594 0.778107 -17 2 1.18753 1.53519 -0.124654 -9.57007 7.63584 -0.456674 -18 2 2.72824 1.67508 -0.226016 0.699647 3.77524 -0.159727 -ITEM: TIMESTEP -60 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.535 -0.173529 1.47468 -12.8115 9.37187 -10.8344 -2 2 -0.673508 -0.564245 1.59147 19.3914 -9.12777 2.73797 -3 2 -2.04099 -0.404174 2.24807 -3.82175 -1.70255 6.71674 -4 1 -1.73996 -0.376347 -1.33351 0.570165 0.280665 -6.43548 -5 2 -1.87928 -0.466718 -0.390362 1.26398 0.876645 10.7815 -6 2 -2.48657 -0.801116 -1.75201 -2.14828 -1.00411 -3.66812 -7 1 -0.576718 1.99595 -0.131852 3.14419 3.30092 -1.47913 -8 2 -0.97416 1.49195 0.577492 -1.32391 -2.58987 8.72867 -9 2 -0.983297 1.63168 -0.91691 -0.334419 -0.770035 -7.07098 -10 1 1.00791 -1.1681 1.41401 -6.20027 1.07549 12.575 -11 2 0.972875 -1.65454 0.593802 -0.476084 -5.46772 -10.3478 -12 2 1.54632 -0.404877 1.20306 3.83119 5.88484 -0.834958 -13 1 0.966385 -1.38017 -1.32091 1.49436 -4.60495 -1.57148 -14 2 0.0722824 -1.10128 -1.51274 -8.16812 -0.531008 -1.13308 -15 2 1.45394 -0.565765 -1.20718 7.01226 4.42564 1.66198 -16 1 2.01308 1.04537 -0.116618 6.94232 -7.944 0.350248 -17 2 1.19126 1.53332 -0.135036 -13.3157 5.74475 0.221956 -18 2 2.70715 1.69348 -0.205764 4.95008 2.7812 -0.398561 -ITEM: TIMESTEP -70 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.52447 -0.177745 1.47754 -14.009 12.5988 -14.9127 -2 2 -0.663619 -0.56979 1.57126 20.9018 -10.2143 3.8986 -3 2 -2.00537 -0.388653 2.26816 -5.41735 -2.91391 10.0958 -4 1 -1.74327 -0.377755 -1.33511 7.69657 4.1782 -9.73798 -5 2 -1.88018 -0.439682 -0.388162 -4.07322 -2.33918 9.17346 -6 2 -2.47021 -0.801057 -1.79014 -4.11028 -2.07522 1.70143 -7 1 -0.576352 1.99233 -0.135801 8.33914 8.33997 -1.40304 -8 2 -0.93279 1.50467 0.607511 -5.01196 -5.05095 3.69276 -9 2 -0.967697 1.61396 -0.924499 -2.96791 -3.60448 -2.11522 -10 1 0.996682 -1.16249 1.41603 -5.52393 -2.7768 9.00886 -11 2 0.982553 -1.62276 0.577115 -1.00274 -4.80219 -7.71302 -12 2 1.55168 -0.404501 1.24312 4.97383 8.09577 -0.603791 -13 1 0.964232 -1.37715 -1.32734 3.83388 -12.0598 -0.0980446 -14 2 0.0575072 -1.10802 -1.48098 -4.628 4.85469 -1.01689 -15 2 1.48931 -0.58697 -1.19891 1.1914 7.02562 -0.119366 -16 1 2.01083 1.04528 -0.114231 6.83173 -12.9986 1.26494 -17 2 1.17034 1.50303 -0.133551 -9.79274 8.34256 -0.476042 -18 2 2.7022 1.69874 -0.182183 2.76884 5.3999 -0.639748 -ITEM: TIMESTEP -80 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.51177 -0.182537 1.47592 -13.1365 10.3139 -11.8951 -2 2 -0.654143 -0.583091 1.57918 18.6975 -8.17701 1.44433 -3 2 -1.97348 -0.365352 2.2852 -6.58467 -1.56222 9.05296 -4 1 -1.74352 -0.377279 -1.33693 -0.505822 0.308788 -3.25308 -5 2 -1.91188 -0.438855 -0.39405 1.95743 0.358158 9.20234 -6 2 -2.48397 -0.807922 -1.76244 -1.16931 -0.70018 -3.86005 -7 1 -0.571778 1.99034 -0.138544 1.3921 0.315501 -1.43854 -8 2 -0.938419 1.50232 0.602337 -1.22478 -1.30903 4.8686 -9 2 -0.959599 1.56918 -0.90914 -0.0288155 0.574454 -3.52808 -10 1 0.985435 -1.15713 1.41811 -6.25848 -6.25702 9.27302 -11 2 0.972167 -1.59168 0.560031 1.69554 -0.201305 -5.06875 -12 2 1.54032 -0.386652 1.30283 4.96928 5.72762 -4.15176 -13 1 0.963614 -1.3793 -1.33436 0.183354 -1.1048 0.823621 -14 2 0.065336 -1.06423 -1.45856 -4.4409 -1.33366 -2.05511 -15 2 1.49256 -0.587857 -1.21654 4.36346 2.23441 0.338535 -16 1 2.00803 1.04345 -0.110717 3.61274 -3.25471 0.639326 -17 2 1.16919 1.51061 -0.133404 -8.46417 2.50048 0.10369 -18 2 2.67828 1.72068 -0.16597 4.94198 1.56662 -0.49597 -ITEM: TIMESTEP -90 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.50159 -0.186388 1.47232 -10.1666 8.56134 -9.06842 -2 2 -0.637201 -0.589948 1.58141 9.00709 -5.13609 3.43504 -3 2 -1.97805 -0.327506 2.28752 -1.76215 -2.05269 5.01359 -4 1 -1.7485 -0.377921 -1.33249 5.81313 3.27044 -5.4853 -5 2 -1.87141 -0.433051 -0.37781 -3.50795 -2.5324 4.09176 -6 2 -2.48522 -0.804273 -1.77362 -2.18894 -1.0456 2.79096 -7 1 -0.568425 1.98378 -0.140489 1.33268 1.60885 -0.760228 -8 2 -0.945484 1.51375 0.61188 -1.03442 -1.79649 -0.570033 -9 2 -0.936389 1.56212 -0.924193 -1.07342 -0.200973 1.02154 -10 1 0.975854 -1.15481 1.42351 1.86741 -2.52595 -4.21318 -11 2 0.98193 -1.53917 0.537259 -2.6087 -4.02599 1.03016 -12 2 1.52752 -0.379325 1.30866 2.98513 5.11632 2.51897 -13 1 0.962056 -1.37771 -1.33914 1.58342 -3.36145 0.893222 -14 2 0.0608833 -1.06855 -1.4877 0.530861 1.7595 -0.414339 -15 2 1.52774 -0.603203 -1.25083 -2.15602 1.98356 -0.537593 -16 1 2.00483 1.04652 -0.10624 2.44039 -5.05754 0.604689 -17 2 1.15126 1.49959 -0.126569 -0.261743 3.34267 -0.115684 -18 2 2.69252 1.71134 -0.15978 -0.800158 2.09248 -0.235157 -ITEM: TIMESTEP -100 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.49915 -0.184572 1.46491 -1.64286 -0.923423 4.11541 -2 2 -0.634606 -0.601439 1.61658 -0.503947 1.48506 -2.91046 -3 2 -1.9835 -0.312527 2.28463 -1.23961 0.673264 -1.96712 -4 1 -1.74898 -0.375873 -1.32741 -4.05983 -3.09974 1.92324 -5 2 -1.86884 -0.471305 -0.372769 3.24632 2.33491 1.76011 -6 2 -2.50916 -0.806172 -1.72327 1.14638 0.924599 -3.12385 -7 1 -0.564884 1.97778 -0.142101 -4.14881 -3.0738 -0.168062 -8 2 -0.958996 1.4911 0.595477 2.25574 1.20147 -1.85844 -9 2 -0.937749 1.56372 -0.930264 1.31445 2.00952 1.76263 -10 1 0.975211 -1.15256 1.42364 -0.947501 -4.6035 2.62584 -11 2 0.950951 -1.55837 0.541757 3.10583 4.89391 1.85772 -12 2 1.52342 -0.363228 1.34082 0.672959 -1.69053 -5.30235 -13 1 0.962361 -1.37851 -1.34242 -1.40487 6.54708 -1.50719 -14 2 0.0703818 -1.05861 -1.53269 1.44041 -3.14031 1.12109 -15 2 1.51335 -0.586474 -1.29057 -0.612624 -3.69916 1.63647 -16 1 2.00445 1.04687 -0.100669 -1.02523 8.04786 -0.336895 -17 2 1.16075 1.52969 -0.119062 2.24423 -4.67525 0.190963 -18 2 2.68635 1.72058 -0.160395 0.158945 -3.21195 0.180894 diff --git a/examples/amoeba/dump.water_hexamer.amoeba.4 b/examples/amoeba/dump.water_hexamer.amoeba.4 deleted file mode 100644 index 88e888cc45..0000000000 --- a/examples/amoeba/dump.water_hexamer.amoeba.4 +++ /dev/null @@ -1,297 +0,0 @@ -ITEM: TIMESTEP -0 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.50217 -0.191359 1.43493 15.8836 -7.45837 3.84323 -2 2 -0.601054 -0.596972 1.55372 -22.9153 9.01978 -0.990133 -3 2 -2.0067 -0.422327 2.21985 1.01155 0.118537 -0.791932 -4 1 -1.74457 -0.382348 -1.30914 -6.66041 -3.92202 8.41554 -5 2 -1.88894 -0.479653 -0.347624 4.77968 3.15053 -8.64245 -6 2 -2.51683 -0.766765 -1.73377 2.90782 1.57916 -0.744558 -7 1 -0.560409 2.01783 -0.121984 -13.2194 -12.8195 1.43178 -8 2 -0.94772 1.53357 0.625228 6.08473 6.021 -1.58068 -9 2 -0.989831 1.59274 -0.877419 5.83415 5.52991 -0.337029 -10 1 0.964803 -1.16576 1.43999 12.6547 2.88136 -21.3636 -11 2 0.979557 -1.52204 0.527833 -3.6968 -1.92725 12.6575 -12 2 1.54222 -0.393692 1.34437 -3.37883 -2.73031 5.998 -13 1 0.974705 -1.4015 -1.33597 -6.12193 14.8514 -0.790538 -14 2 0.065161 -1.11895 -1.52289 4.56017 -6.05436 1.71545 -15 2 1.47071 -0.570933 -1.27771 1.31912 -7.40942 1.06098 -16 1 2.00228 1.05782 -0.124502 -10.3736 10.8414 -1.12005 -17 2 1.14164 1.53227 -0.140121 11.8812 -8.20067 0.772116 -18 2 2.67472 1.73534 -0.237995 -0.550493 -3.47117 0.466398 -ITEM: TIMESTEP -10 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.50661 -0.189383 1.4364 14.5938 -8.99605 8.72579 -2 2 -0.616993 -0.604745 1.5716 -17.7352 9.03346 -4.01613 -3 2 -2.01184 -0.421588 2.22126 -0.664878 1.39015 -2.52743 -4 1 -1.74564 -0.383429 -1.31051 0.451442 -0.432875 3.71075 -5 2 -1.85676 -0.451272 -0.342641 -1.17801 0.27861 -9.12816 -6 2 -2.51648 -0.764704 -1.74119 1.00433 0.523826 3.94489 -7 1 -0.565581 2.01415 -0.121947 -0.431671 0.816258 1.37224 -8 2 -0.923503 1.54613 0.649943 -0.836345 -0.35076 -8.91816 -9 2 -0.954982 1.61593 -0.9136 -0.398984 -1.29665 6.9827 -10 1 0.971315 -1.16462 1.43403 2.66632 -4.10463 -4.1745 -11 2 0.960388 -1.57587 0.54557 3.80791 8.56867 8.0783 -12 2 1.545 -0.38505 1.37422 -2.3984 -5.62816 -5.66197 -13 1 0.972827 -1.39712 -1.33549 -1.10638 0.442925 0.267527 -14 2 0.0526434 -1.14464 -1.51395 7.06933 2.8298 1.48943 -15 2 1.50554 -0.590868 -1.25662 -6.54392 -2.53639 -0.258333 -16 1 2.00275 1.0584 -0.124848 -7.13185 5.38221 -0.0306111 -17 2 1.13969 1.52381 -0.134074 11.7308 -4.5992 -0.113372 -18 2 2.68869 1.72277 -0.237084 -2.89819 -1.32119 0.257039 -ITEM: TIMESTEP -20 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.51649 -0.18584 1.44395 5.65501 -4.20149 4.07802 -2 2 -0.637196 -0.60535 1.5789 -10.2535 4.51311 -0.350867 -3 2 -2.05196 -0.408647 2.21473 3.52072 0.575858 -3.20585 -4 1 -1.74216 -0.383007 -1.31779 -5.65244 -1.7459 7.46957 -5 2 -1.85838 -0.422286 -0.35262 3.57624 0.698487 -5.03248 -6 2 -2.53778 -0.772973 -1.68856 2.62304 1.05785 -2.46299 -7 1 -0.568621 2.01502 -0.121788 -7.49291 -10.5083 -0.07078 -8 2 -0.953332 1.50031 0.601729 3.90339 5.1027 1.32659 -9 2 -0.948304 1.59097 -0.90055 3.2198 4.86429 -1.5712 -10 1 0.981527 -1.16776 1.43139 8.19382 2.30469 -14.0571 -11 2 0.999682 -1.57682 0.548153 -4.17545 -1.46604 7.90595 -12 2 1.55686 -0.401102 1.29785 -3.41945 -1.35828 5.31582 -13 1 0.971997 -1.39727 -1.33295 -3.50737 11.1512 0.685267 -14 2 0.0679408 -1.0929 -1.49373 1.59713 -5.72522 -0.144088 -15 2 1.47933 -0.582056 -1.22295 2.04209 -4.76253 -0.234646 -16 1 2.00557 1.05551 -0.12468 -4.4992 7.40197 -0.448564 -17 2 1.16008 1.5422 -0.129327 5.1837 -4.83397 0.46283 -18 2 2.69054 1.72007 -0.238059 -0.51465 -3.06849 0.334482 -ITEM: TIMESTEP -30 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.52872 -0.18011 1.45173 -0.933277 -2.21949 5.98424 -2 2 -0.665459 -0.602256 1.60472 0.633036 0.719099 -1.22127 -3 2 -2.07366 -0.404666 2.21589 2.60377 1.4581 -4.42661 -4 1 -1.74225 -0.382648 -1.3226 2.4731 1.57235 -0.799694 -5 2 -1.81423 -0.398932 -0.35676 -3.06045 -1.92828 -1.63228 -6 2 -2.5352 -0.77665 -1.69294 0.0233925 -0.139311 2.03217 -7 1 -0.576286 2.0073 -0.122823 5.68391 5.42307 0.543301 -8 2 -0.95235 1.50691 0.611905 -2.48677 -2.29116 -3.6455 -9 2 -0.915502 1.63076 -0.941481 -3.12923 -3.02599 2.90572 -10 1 0.998541 -1.16996 1.42191 -2.76709 -0.0175982 4.85417 -11 2 0.970261 -1.63876 0.575717 2.4618 4.28015 -0.493825 -12 2 1.54742 -0.386783 1.27666 -1.41861 -3.70889 -3.67396 -13 1 0.969317 -1.3895 -1.32829 2.03562 -5.48364 0.295138 -14 2 0.0583035 -1.11723 -1.49206 1.73159 3.49229 -0.0543931 -15 2 1.50655 -0.600283 -1.19205 -3.9925 1.94925 -1.04523 -16 1 2.00848 1.05446 -0.124132 1.88868 -1.58075 0.754117 -17 2 1.16959 1.53865 -0.11771 0.573913 1.34283 -0.58573 -18 2 2.71517 1.69464 -0.239075 -2.32089 0.157967 0.209615 -ITEM: TIMESTEP -40 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.53726 -0.175397 1.46121 -7.56641 2.45844 -0.518817 -2 2 -0.675238 -0.584022 1.60915 7.85196 -3.99237 1.67217 -3 2 -2.08862 -0.402087 2.21789 3.0617 0.39778 -2.04562 -4 1 -1.73949 -0.379604 -1.32819 -2.36016 -0.787528 -0.0315325 -5 2 -1.83346 -0.428429 -0.37056 1.90026 0.717301 4.17358 -6 2 -2.53017 -0.786871 -1.68316 0.151557 -0.108901 -3.75615 -7 1 -0.576955 2.0043 -0.124416 -0.431513 -1.54355 -1.46354 -8 2 -0.992092 1.48382 0.567817 1.09284 0.418387 6.78235 -9 2 -0.944746 1.62819 -0.925975 0.76441 1.37882 -5.22407 -10 1 1.00941 -1.17308 1.4189 -1.85973 4.64458 1.0889 -11 2 0.973659 -1.6403 0.580693 -1.69219 -4.78957 -3.29195 -12 2 1.53559 -0.396477 1.19908 0.544307 1.46508 3.63166 -13 1 0.969009 -1.38744 -1.3228 -0.275569 1.85307 -0.63583 -14 2 0.0737932 -1.09141 -1.50366 -4.66851 -2.83882 -1.16892 -15 2 1.46633 -0.576681 -1.19175 5.00795 0.70617 0.521536 -16 1 2.01183 1.05054 -0.121932 4.41526 -1.70685 -0.0836272 -17 2 1.19121 1.55327 -0.120038 -7.25224 2.19125 0.154184 -18 2 2.71636 1.68982 -0.237383 1.31607 -0.463304 0.195666 -ITEM: TIMESTEP -50 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.53986 -0.172749 1.46865 -10.3641 5.96951 -4.41562 -2 2 -0.678724 -0.568486 1.60775 14.9207 -7.13278 2.04782 -3 2 -2.07217 -0.405364 2.23045 -0.725799 -0.490948 1.77161 -4 1 -1.74113 -0.378171 -1.32957 5.99712 2.85952 -9.13842 -5 2 -1.82713 -0.447378 -0.375703 -3.89226 -1.3818 7.11516 -6 2 -2.4999 -0.790471 -1.74187 -3.02333 -1.60416 1.77146 -7 1 -0.579496 1.99691 -0.128028 9.72738 10.7655 -0.463519 -8 2 -0.97832 1.50522 0.591572 -4.4866 -5.64841 2.33138 -9 2 -0.951447 1.66071 -0.944057 -3.97244 -4.92262 -1.79974 -10 1 1.01358 -1.17192 1.41393 -6.48605 2.83151 13.495 -11 2 0.960671 -1.668 0.598799 0.887838 -3.18341 -9.75086 -12 2 1.53449 -0.394669 1.19537 2.46945 2.14925 -1.89795 -13 1 0.966791 -1.38037 -1.31946 4.73561 -12.449 -1.17286 -14 2 0.0653014 -1.12956 -1.52441 -4.76491 5.51904 -0.304595 -15 2 1.48076 -0.580834 -1.19775 0.0522693 6.36707 0.249418 -16 1 2.01309 1.04924 -0.119438 7.79557 -11.0594 0.778107 -17 2 1.18753 1.53519 -0.124654 -9.57007 7.63584 -0.456674 -18 2 2.72824 1.67508 -0.226016 0.699647 3.77524 -0.159727 -ITEM: TIMESTEP -60 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.535 -0.173529 1.47468 -12.8115 9.37187 -10.8344 -2 2 -0.673508 -0.564245 1.59147 19.3914 -9.12777 2.73797 -3 2 -2.04099 -0.404174 2.24807 -3.82175 -1.70255 6.71674 -4 1 -1.73996 -0.376347 -1.33351 0.570165 0.280665 -6.43548 -5 2 -1.87928 -0.466718 -0.390362 1.26398 0.876645 10.7815 -6 2 -2.48657 -0.801116 -1.75201 -2.14828 -1.00411 -3.66812 -7 1 -0.576718 1.99595 -0.131852 3.14419 3.30092 -1.47913 -8 2 -0.97416 1.49195 0.577492 -1.32391 -2.58987 8.72867 -9 2 -0.983297 1.63168 -0.91691 -0.334419 -0.770035 -7.07098 -10 1 1.00791 -1.1681 1.41401 -6.20027 1.07549 12.575 -11 2 0.972875 -1.65454 0.593802 -0.476084 -5.46772 -10.3478 -12 2 1.54632 -0.404877 1.20306 3.83119 5.88484 -0.834958 -13 1 0.966385 -1.38017 -1.32091 1.49436 -4.60495 -1.57148 -14 2 0.0722824 -1.10128 -1.51274 -8.16812 -0.531008 -1.13308 -15 2 1.45394 -0.565765 -1.20718 7.01226 4.42564 1.66198 -16 1 2.01308 1.04537 -0.116618 6.94232 -7.944 0.350248 -17 2 1.19126 1.53332 -0.135036 -13.3157 5.74475 0.221956 -18 2 2.70715 1.69348 -0.205764 4.95008 2.7812 -0.398561 -ITEM: TIMESTEP -70 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.52447 -0.177745 1.47754 -14.009 12.5988 -14.9127 -2 2 -0.663619 -0.56979 1.57126 20.9018 -10.2143 3.8986 -3 2 -2.00537 -0.388653 2.26816 -5.41735 -2.91391 10.0958 -4 1 -1.74327 -0.377755 -1.33511 7.69657 4.1782 -9.73798 -5 2 -1.88018 -0.439682 -0.388162 -4.07322 -2.33918 9.17346 -6 2 -2.47021 -0.801057 -1.79014 -4.11028 -2.07522 1.70143 -7 1 -0.576352 1.99233 -0.135801 8.33914 8.33997 -1.40304 -8 2 -0.93279 1.50467 0.607511 -5.01196 -5.05095 3.69276 -9 2 -0.967697 1.61396 -0.924499 -2.96791 -3.60448 -2.11522 -10 1 0.996682 -1.16249 1.41603 -5.52393 -2.7768 9.00886 -11 2 0.982553 -1.62276 0.577115 -1.00274 -4.80219 -7.71302 -12 2 1.55168 -0.404501 1.24312 4.97383 8.09577 -0.603791 -13 1 0.964232 -1.37715 -1.32734 3.83388 -12.0598 -0.0980446 -14 2 0.0575072 -1.10802 -1.48098 -4.628 4.85469 -1.01689 -15 2 1.48931 -0.58697 -1.19891 1.1914 7.02562 -0.119366 -16 1 2.01083 1.04528 -0.114231 6.83173 -12.9986 1.26494 -17 2 1.17034 1.50303 -0.133551 -9.79274 8.34256 -0.476042 -18 2 2.7022 1.69874 -0.182183 2.76884 5.3999 -0.639748 -ITEM: TIMESTEP -80 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.51177 -0.182537 1.47592 -13.1365 10.3139 -11.8951 -2 2 -0.654143 -0.583091 1.57918 18.6975 -8.17701 1.44433 -3 2 -1.97348 -0.365352 2.2852 -6.58467 -1.56222 9.05296 -4 1 -1.74352 -0.377279 -1.33693 -0.505822 0.308788 -3.25308 -5 2 -1.91188 -0.438855 -0.39405 1.95743 0.358158 9.20234 -6 2 -2.48397 -0.807922 -1.76244 -1.16931 -0.70018 -3.86005 -7 1 -0.571778 1.99034 -0.138544 1.3921 0.315501 -1.43854 -8 2 -0.938419 1.50232 0.602337 -1.22478 -1.30903 4.8686 -9 2 -0.959599 1.56918 -0.90914 -0.0288155 0.574454 -3.52808 -10 1 0.985435 -1.15713 1.41811 -6.25848 -6.25702 9.27302 -11 2 0.972167 -1.59168 0.560031 1.69554 -0.201305 -5.06875 -12 2 1.54032 -0.386652 1.30283 4.96928 5.72762 -4.15176 -13 1 0.963614 -1.3793 -1.33436 0.183354 -1.1048 0.823621 -14 2 0.065336 -1.06423 -1.45856 -4.4409 -1.33366 -2.05511 -15 2 1.49256 -0.587857 -1.21654 4.36346 2.23441 0.338535 -16 1 2.00803 1.04345 -0.110717 3.61274 -3.25471 0.639326 -17 2 1.16919 1.51061 -0.133404 -8.46417 2.50048 0.10369 -18 2 2.67828 1.72068 -0.16597 4.94198 1.56662 -0.49597 -ITEM: TIMESTEP -90 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.50159 -0.186388 1.47232 -10.1666 8.56134 -9.06842 -2 2 -0.637201 -0.589948 1.58141 9.00709 -5.13609 3.43504 -3 2 -1.97805 -0.327506 2.28752 -1.76215 -2.05269 5.01359 -4 1 -1.7485 -0.377921 -1.33249 5.81313 3.27044 -5.4853 -5 2 -1.87141 -0.433051 -0.37781 -3.50795 -2.5324 4.09176 -6 2 -2.48522 -0.804273 -1.77362 -2.18894 -1.0456 2.79096 -7 1 -0.568425 1.98378 -0.140489 1.33268 1.60885 -0.760228 -8 2 -0.945484 1.51375 0.61188 -1.03442 -1.79649 -0.570033 -9 2 -0.936389 1.56212 -0.924193 -1.07342 -0.200973 1.02154 -10 1 0.975854 -1.15481 1.42351 1.86741 -2.52595 -4.21318 -11 2 0.98193 -1.53917 0.537259 -2.6087 -4.02599 1.03016 -12 2 1.52752 -0.379325 1.30866 2.98513 5.11632 2.51897 -13 1 0.962056 -1.37771 -1.33914 1.58342 -3.36145 0.893222 -14 2 0.0608833 -1.06855 -1.4877 0.530861 1.7595 -0.414339 -15 2 1.52774 -0.603203 -1.25083 -2.15602 1.98356 -0.537593 -16 1 2.00483 1.04652 -0.10624 2.44039 -5.05754 0.604689 -17 2 1.15126 1.49959 -0.126569 -0.261743 3.34267 -0.115684 -18 2 2.69252 1.71134 -0.15978 -0.800158 2.09248 -0.235157 -ITEM: TIMESTEP -100 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.49915 -0.184572 1.46491 -1.64286 -0.923423 4.11541 -2 2 -0.634606 -0.601439 1.61658 -0.503947 1.48506 -2.91046 -3 2 -1.9835 -0.312527 2.28463 -1.23961 0.673264 -1.96712 -4 1 -1.74898 -0.375873 -1.32741 -4.05983 -3.09974 1.92324 -5 2 -1.86884 -0.471305 -0.372769 3.24632 2.33491 1.76011 -6 2 -2.50916 -0.806172 -1.72327 1.14638 0.924599 -3.12385 -7 1 -0.564884 1.97778 -0.142101 -4.14881 -3.0738 -0.168062 -8 2 -0.958996 1.4911 0.595477 2.25574 1.20147 -1.85844 -9 2 -0.937749 1.56372 -0.930264 1.31445 2.00952 1.76263 -10 1 0.975211 -1.15256 1.42364 -0.947501 -4.6035 2.62584 -11 2 0.950951 -1.55837 0.541757 3.10583 4.89391 1.85772 -12 2 1.52342 -0.363228 1.34082 0.672959 -1.69053 -5.30235 -13 1 0.962361 -1.37851 -1.34242 -1.40487 6.54708 -1.50719 -14 2 0.0703818 -1.05861 -1.53269 1.44041 -3.14031 1.12109 -15 2 1.51335 -0.586474 -1.29057 -0.612624 -3.69916 1.63647 -16 1 2.00445 1.04687 -0.100669 -1.02523 8.04786 -0.336895 -17 2 1.16075 1.52969 -0.119062 2.24423 -4.67525 0.190963 -18 2 2.68635 1.72058 -0.160395 0.158945 -3.21195 0.180894 diff --git a/examples/amoeba/dump.water_hexamer.hippo.1 b/examples/amoeba/dump.water_hexamer.hippo.1 deleted file mode 100644 index a808eb88d8..0000000000 --- a/examples/amoeba/dump.water_hexamer.hippo.1 +++ /dev/null @@ -1,297 +0,0 @@ -ITEM: TIMESTEP -0 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.50217 -0.191359 1.43493 19.9357 -10.2022 6.39617 -2 2 -0.601054 -0.596972 1.55372 -26.7746 11.7551 -3.2269 -3 2 -2.0067 -0.422327 2.21985 2.27453 0.843475 -3.26617 -4 1 -1.74457 -0.382348 -1.30914 -7.45906 -3.26138 10.4208 -5 2 -1.88894 -0.479653 -0.347624 4.39096 1.86538 -10.993 -6 2 -2.51683 -0.766765 -1.73377 3.97889 2.0308 0.238005 -7 1 -0.560409 2.01783 -0.121984 -15.0354 -12.151 1.41176 -8 2 -0.94772 1.53357 0.625228 7.62359 5.98784 -1.89388 -9 2 -0.989831 1.59274 -0.877419 6.55934 4.96076 0.527359 -10 1 0.964803 -1.16576 1.43999 15.4285 1.35636 -21.3173 -11 2 0.979557 -1.52204 0.527833 -6.23862 0.631634 14.3987 -12 2 1.54222 -0.393692 1.34437 -5.98579 -2.68738 6.2337 -13 1 0.974705 -1.4015 -1.33597 -5.70279 13.9492 -3.53962 -14 2 0.065161 -1.11895 -1.52289 5.16041 -6.4649 2.71211 -15 2 1.47071 -0.570933 -1.27771 0.726496 -6.9774 1.88925 -16 1 2.00228 1.05782 -0.124502 -11.1831 12.6873 -1.41281 -17 2 1.14164 1.53227 -0.140121 14.1175 -10.0366 0.774885 -18 2 2.67472 1.73534 -0.237995 -1.81661 -4.28693 0.646829 -ITEM: TIMESTEP -10 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.50519 -0.189085 1.43489 16.1346 -9.03082 7.39643 -2 2 -0.613325 -0.596599 1.55623 -19.7 9.16793 -3.06694 -3 2 -2.00781 -0.423676 2.21968 1.11569 1.33017 -3.51515 -4 1 -1.74545 -0.38218 -1.30921 -0.873137 -0.924011 5.81502 -5 2 -1.86379 -0.472478 -0.34573 -0.592473 0.521176 -9.80595 -6 2 -2.51308 -0.764814 -1.7423 1.95383 0.883641 3.34899 -7 1 -0.566746 2.01551 -0.121884 -0.752908 0.880358 1.51675 -8 2 -0.90288 1.53899 0.653422 -0.370038 -0.282546 -8.72932 -9 2 -0.948386 1.59852 -0.906373 -0.161598 -1.83495 7.27882 -10 1 0.972994 -1.16632 1.4367 2.1365 -3.63541 -4.30666 -11 2 0.921471 -1.54563 0.536978 3.92948 8.96444 9.02535 -12 2 1.51571 -0.366599 1.37318 -3.05971 -5.7155 -5.67471 -13 1 0.973913 -1.39785 -1.33834 -1.44621 0.344209 -0.720777 -14 2 0.0503221 -1.15099 -1.50181 7.085 2.52089 1.36272 -15 2 1.49605 -0.587274 -1.24124 -6.30793 -2.23617 0.0453877 -16 1 2.00301 1.05777 -0.1249 -8.37521 5.68727 -0.0787125 -17 2 1.13805 1.51682 -0.135757 12.8554 -4.94557 -0.27859 -18 2 2.68412 1.72611 -0.2366 -3.57128 -1.69512 0.387339 -ITEM: TIMESTEP -20 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.51053 -0.184679 1.43662 2.59225 -2.34383 2.4228 -2 2 -0.638864 -0.59446 1.56144 -3.81751 1.45077 0.169365 -3 2 -2.02892 -0.415768 2.21112 1.3915 0.960529 -2.2268 -4 1 -1.7422 -0.380161 -1.31156 -2.81538 -1.6524 5.61723 -5 2 -1.87085 -0.467579 -0.355121 2.06181 1.26201 -3.01668 -6 2 -2.51909 -0.769609 -1.71571 1.56589 0.868196 -2.04346 -7 1 -0.571857 2.01726 -0.121524 -4.42229 -10.7497 0.101549 -8 2 -0.894989 1.49275 0.621756 1.9428 5.13739 2.3456 -9 2 -0.928333 1.53949 -0.878364 1.74391 4.55343 -2.63937 -10 1 0.983665 -1.17004 1.43811 2.15858 5.32924 -12.0192 -11 2 0.916986 -1.51176 0.532863 -0.801958 -4.34579 6.00669 -12 2 1.48632 -0.356933 1.30471 -0.115562 -1.35756 5.38685 -13 1 0.974155 -1.39809 -1.34091 -3.6872 9.81415 2.33229 -14 2 0.0608639 -1.11508 -1.47548 0.727822 -4.45373 -1.43277 -15 2 1.45945 -0.57705 -1.18377 2.74992 -3.83937 -1.32423 -16 1 2.0041 1.05318 -0.12468 -4.82863 5.07797 -0.287867 -17 2 1.15863 1.52924 -0.140109 2.7798 -3.05413 0.358119 -18 2 2.67895 1.72504 -0.234758 0.77424 -2.65718 0.249897 -ITEM: TIMESTEP -30 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.5148 -0.180382 1.43888 -14.0787 7.25927 -2.0787 -2 2 -0.670243 -0.596746 1.58256 15.1847 -7.27642 2.26385 -3 2 -2.0578 -0.394757 2.19803 0.335566 -0.184039 0.277588 -4 1 -1.73953 -0.378972 -1.31065 5.17639 2.63373 -5.13987 -5 2 -1.85923 -0.443728 -0.358889 -2.57415 -1.51426 3.86387 -6 2 -2.50599 -0.762479 -1.73443 -2.25678 -0.997735 0.886673 -7 1 -0.57869 2.00716 -0.122116 7.46708 7.5609 -0.932554 -8 2 -0.891326 1.5227 0.646189 -3.77932 -4.24552 -0.379656 -9 2 -0.906489 1.54888 -0.899539 -3.74504 -3.89196 0.775918 -10 1 0.993915 -1.16716 1.4314 -4.03671 -0.827424 10.5116 -11 2 0.932938 -1.58361 0.567361 1.80347 1.36047 -5.88474 -12 2 1.49414 -0.355801 1.3027 1.34198 0.116597 -4.03649 -13 1 0.970608 -1.38983 -1.33905 4.21477 -7.05635 0.421831 -14 2 0.0575618 -1.13428 -1.49637 -1.45416 4.35852 0.0411765 -15 2 1.48422 -0.594211 -1.16216 -2.77696 3.0816 -1.11496 -16 1 2.00096 1.05017 -0.124007 4.94447 -7.97826 1.06585 -17 2 1.17138 1.53183 -0.140668 -5.63771 5.40691 -0.274313 -18 2 2.7082 1.68479 -0.23083 -0.128954 2.19398 -0.267092 -ITEM: TIMESTEP -40 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.5186 -0.17605 1.44225 -24.1552 14.2056 -8.76949 -2 2 -0.687962 -0.594151 1.59127 27.1026 -13.0552 4.45143 -3 2 -2.07116 -0.378379 2.19317 -1.29427 -1.5252 3.96365 -4 1 -1.73305 -0.375414 -1.31137 2.16372 2.0419 -7.75161 -5 2 -1.87951 -0.450834 -0.370226 0.624847 -0.775772 11.2387 -6 2 -2.50254 -0.754697 -1.72909 -2.50645 -1.07375 -3.54713 -7 1 -0.578876 1.99941 -0.124067 2.19183 2.88771 -2.2033 -8 2 -0.936478 1.52242 0.623048 -0.431918 -2.06784 8.93732 -9 2 -0.943689 1.52907 -0.872983 -0.503357 -0.655131 -7.36871 -10 1 1.00066 -1.16525 1.43041 -2.12968 1.37125 11.5778 -11 2 0.974279 -1.60078 0.583019 -3.02955 -6.45349 -11.2722 -12 2 1.51087 -0.375422 1.25067 2.49642 6.22795 1.24643 -13 1 0.96952 -1.38626 -1.33641 3.1199 -1.09706 -1.06644 -14 2 0.0736705 -1.0998 -1.50988 -8.20047 -1.85824 -0.95018 -15 2 1.45433 -0.57243 -1.18601 5.63783 2.37426 1.20997 -16 1 1.9962 1.04317 -0.122075 10.6231 -9.89832 0.540427 -17 2 1.19663 1.55837 -0.138658 -15.3708 7.22601 0.146924 -18 2 2.71508 1.6609 -0.228386 3.66149 2.12531 -0.383549 -ITEM: TIMESTEP -50 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.52326 -0.171807 1.44556 -19.3809 13.2253 -10.6114 -2 2 -0.679923 -0.574818 1.57581 25.4624 -12.0419 4.4477 -3 2 -2.05017 -0.382025 2.20867 -3.53537 -2.33472 6.62258 -4 1 -1.72947 -0.37135 -1.31158 7.45117 4.03521 -12.7525 -5 2 -1.85272 -0.46757 -0.370426 -4.08312 -1.86842 12.0545 -6 2 -2.4914 -0.737252 -1.75485 -4.03109 -2.01148 0.403261 -7 1 -0.581812 1.98886 -0.127591 8.73336 12.0451 -2.23223 -8 2 -0.927295 1.54015 0.641551 -4.26906 -6.45964 5.24049 -9 2 -0.953055 1.5416 -0.887204 -3.28906 -5.2042 -3.24355 -10 1 1.00866 -1.16393 1.43094 -5.76797 0.688141 16.3003 -11 2 0.941718 -1.59751 0.586621 -0.69625 -5.79697 -13.9615 -12 2 1.5005 -0.365594 1.24465 4.16474 6.46538 -1.29083 -13 1 0.968591 -1.37822 -1.33754 5.88173 -13.6635 -0.995409 -14 2 0.058765 -1.13465 -1.50083 -6.65826 5.43105 -0.991523 -15 2 1.47128 -0.574689 -1.20309 0.663977 7.53437 1.14922 -16 1 1.99172 1.03702 -0.120004 11.7209 -15.9347 1.25003 -17 2 1.18616 1.54124 -0.127765 -14.4197 10.6401 -0.950727 -18 2 2.7224 1.64022 -0.223578 2.05256 5.25094 -0.438473 -ITEM: TIMESTEP -60 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.52514 -0.169424 1.44931 -5.6044 5.71407 -7.65735 -2 2 -0.654856 -0.548823 1.55951 12.8877 -6.19997 1.70589 -3 2 -2.01089 -0.399975 2.23335 -4.71544 -1.47688 6.26364 -4 1 -1.72371 -0.366036 -1.3145 0.154709 0.0103655 -5.79078 -5 2 -1.86537 -0.486382 -0.375504 0.204748 0.738589 9.60402 -6 2 -2.49691 -0.728317 -1.74343 -1.12209 -0.453095 -3.27306 -7 1 -0.582396 1.98478 -0.131637 3.0799 3.10149 -1.36944 -8 2 -0.917703 1.51358 0.63199 -1.67497 -1.52591 5.69623 -9 2 -0.95935 1.51373 -0.876424 -0.704912 -1.0485 -4.50039 -10 1 1.01141 -1.16147 1.43332 -7.40944 0.284109 12.5023 -11 2 0.911102 -1.56686 0.573359 1.73368 -3.47737 -10.1102 -12 2 1.49548 -0.352196 1.26684 4.34342 4.22027 -2.29553 -13 1 0.969684 -1.37685 -1.34222 -0.51092 -4.11589 -0.224969 -14 2 0.0587056 -1.1173 -1.48363 -6.15339 -0.904158 -2.27293 -15 2 1.44029 -0.555019 -1.20354 6.44357 4.32801 1.75924 -16 1 1.98854 1.02727 -0.117121 5.38674 -4.81439 0.472007 -17 2 1.17286 1.52668 -0.137432 -10.3716 4.01885 -0.196355 -18 2 2.69 1.66639 -0.213741 4.03261 1.60042 -0.312306 -ITEM: TIMESTEP -70 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.52005 -0.170765 1.45435 7.42813 -0.682132 -3.31568 -2 2 -0.627795 -0.545781 1.54703 -4.484 0.351316 0.767932 -3 2 -1.9938 -0.405389 2.24937 -1.65789 -0.838399 2.61041 -4 1 -1.72181 -0.363627 -1.31513 2.63115 1.26887 -2.8752 -5 2 -1.86247 -0.45623 -0.365408 -2.65258 -1.1368 1.02525 -6 2 -2.4895 -0.712321 -1.77001 -0.898587 -0.369019 2.21573 -7 1 -0.583063 1.97962 -0.135858 1.67055 0.570004 -0.383383 -8 2 -0.908051 1.51128 0.64094 -1.16679 -0.0785678 -0.520586 -9 2 -0.943124 1.49995 -0.888932 -0.754685 -0.199723 0.596245 -10 1 1.00431 -1.15529 1.43647 -0.676345 0.911353 -2.95012 -11 2 0.95109 -1.53365 0.551095 -1.85378 -3.64627 0.0738184 -12 2 1.52689 -0.36229 1.29214 1.34973 2.90443 2.73267 -13 1 0.96764 -1.3732 -1.34735 0.830518 -7.82237 0.0710001 -14 2 0.049796 -1.13062 -1.50565 0.0671147 3.17314 0.120857 -15 2 1.46341 -0.566541 -1.18509 -0.178936 4.65822 -0.507667 -16 1 1.98438 1.02188 -0.114233 -0.881295 -2.57322 0.275288 -17 2 1.13419 1.48172 -0.149659 1.87909 1.86036 0.463365 -18 2 2.6735 1.67987 -0.202074 -0.651386 1.64881 -0.399918 -ITEM: TIMESTEP -80 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.50978 -0.173017 1.45833 15.0482 -9.57345 5.77126 -2 2 -0.617503 -0.581602 1.56045 -17.3455 8.85736 -2.90765 -3 2 -1.99215 -0.403845 2.25671 0.833211 1.42908 -3.53001 -4 1 -1.71857 -0.360372 -1.31644 -7.32338 -2.11362 6.45601 -5 2 -1.89982 -0.440583 -0.365391 4.39327 0.727605 -4.87947 -6 2 -2.49827 -0.701359 -1.75982 2.51785 1.20426 -1.18541 -7 1 -0.581108 1.97455 -0.140769 -3.87733 -3.80002 1.10694 -8 2 -0.928789 1.51932 0.641149 2.19408 2.20718 -5.07369 -9 2 -0.943839 1.48954 -0.89443 1.32563 2.05291 3.72773 -10 1 0.995847 -1.14613 1.43537 0.755936 -5.6909 -0.46639 -11 2 0.966841 -1.55186 0.550806 1.56938 7.42451 5.54707 -12 2 1.55511 -0.362342 1.35836 -2.79165 -2.9995 -5.36768 -13 1 0.967816 -1.37465 -1.35163 -3.29308 4.65803 -0.872226 -14 2 0.0602027 -1.09254 -1.5264 2.56737 -3.64929 1.27094 -15 2 1.45854 -0.559392 -1.19328 1.84002 -1.84978 0.0538636 -16 1 1.98052 1.0158 -0.111184 -7.14388 11.5516 -0.816233 -17 2 1.12003 1.47724 -0.140032 8.70268 -6.85942 1.26876 -18 2 2.64114 1.706 -0.201685 0.0272078 -3.57662 -0.103793 -ITEM: TIMESTEP -90 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.50003 -0.175917 1.46165 15.3898 -11.884 8.8546 -2 2 -0.608584 -0.600731 1.57129 -23.7815 11.9323 -1.75151 -3 2 -2.00991 -0.394435 2.25305 5.57059 1.55514 -7.64598 -4 1 -1.72137 -0.357368 -1.31563 -1.93902 -0.246344 7.85181 -5 2 -1.87234 -0.43987 -0.353482 -0.118832 -0.772284 -11.4834 -6 2 -2.49861 -0.682857 -1.77755 1.48512 0.513779 4.12935 -7 1 -0.579472 1.97061 -0.145894 -8.85759 -8.26094 2.77276 -8 2 -0.945449 1.52054 0.635243 4.66427 4.57627 -6.94972 -9 2 -0.952686 1.48464 -0.897126 3.60343 4.09955 4.74753 -10 1 0.988258 -1.14419 1.44127 11.1074 1.88534 -20.9154 -11 2 0.971991 -1.50516 0.531218 -4.29535 0.162687 14.3489 -12 2 1.5415 -0.356231 1.32305 -5.76468 -4.25266 5.91571 -13 1 0.969416 -1.37359 -1.35605 -1.23717 3.53556 0.174563 -14 2 0.053578 -1.1004 -1.52114 7.10928 -0.236326 1.96556 -15 2 1.49219 -0.569722 -1.21186 -5.0738 -3.24139 -1.5161 -16 1 1.97824 1.01566 -0.108279 -8.95647 8.69277 0.191958 -17 2 1.10027 1.45664 -0.104435 15.9218 -5.21388 -1.22481 -18 2 2.64464 1.70165 -0.21558 -4.82724 -2.84557 0.534172 -ITEM: TIMESTEP -100 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.4951 -0.17739 1.46185 11.6291 -12.0775 13.5087 -2 2 -0.608426 -0.588808 1.60852 -19.0988 9.4339 -4.86631 -3 2 -2.01619 -0.397996 2.24676 4.77562 3.06476 -9.1756 -4 1 -1.72287 -0.352149 -1.31567 -8.10325 -4.84048 12.8242 -5 2 -1.86729 -0.479262 -0.356777 4.49726 3.58866 -11.0242 -6 2 -2.51926 -0.676876 -1.74282 3.42966 1.20159 -1.20299 -7 1 -0.581355 1.96754 -0.149521 -5.24612 -4.66563 2.71982 -8 2 -0.935394 1.51644 0.636953 2.89489 2.96603 -9.31226 -9 2 -0.942573 1.488 -0.91114 1.96254 2.34604 7.29302 -10 1 0.988651 -1.14425 1.44045 0.840008 -1.36718 -7.83612 -11 2 0.899639 -1.53136 0.543246 5.64911 9.69241 11.7913 -12 2 1.49178 -0.318235 1.33897 -3.7582 -9.86315 -4.79205 -13 1 0.974233 -1.37573 -1.35945 -3.77942 11.331 0.435153 -14 2 0.0583408 -1.08758 -1.49668 6.15796 -3.89994 -0.197074 -15 2 1.48764 -0.558876 -1.24121 -3.14566 -8.24544 0.525665 -16 1 1.97883 1.01496 -0.10404 -9.03485 15.6667 -0.929518 -17 2 1.11471 1.47883 -0.106249 11.9101 -8.77208 -0.858699 -18 2 2.63671 1.70526 -0.232286 -1.57994 -5.55972 1.09694 diff --git a/examples/amoeba/dump.water_hexamer.hippo.4 b/examples/amoeba/dump.water_hexamer.hippo.4 deleted file mode 100644 index a808eb88d8..0000000000 --- a/examples/amoeba/dump.water_hexamer.hippo.4 +++ /dev/null @@ -1,297 +0,0 @@ -ITEM: TIMESTEP -0 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.50217 -0.191359 1.43493 19.9357 -10.2022 6.39617 -2 2 -0.601054 -0.596972 1.55372 -26.7746 11.7551 -3.2269 -3 2 -2.0067 -0.422327 2.21985 2.27453 0.843475 -3.26617 -4 1 -1.74457 -0.382348 -1.30914 -7.45906 -3.26138 10.4208 -5 2 -1.88894 -0.479653 -0.347624 4.39096 1.86538 -10.993 -6 2 -2.51683 -0.766765 -1.73377 3.97889 2.0308 0.238005 -7 1 -0.560409 2.01783 -0.121984 -15.0354 -12.151 1.41176 -8 2 -0.94772 1.53357 0.625228 7.62359 5.98784 -1.89388 -9 2 -0.989831 1.59274 -0.877419 6.55934 4.96076 0.527359 -10 1 0.964803 -1.16576 1.43999 15.4285 1.35636 -21.3173 -11 2 0.979557 -1.52204 0.527833 -6.23862 0.631634 14.3987 -12 2 1.54222 -0.393692 1.34437 -5.98579 -2.68738 6.2337 -13 1 0.974705 -1.4015 -1.33597 -5.70279 13.9492 -3.53962 -14 2 0.065161 -1.11895 -1.52289 5.16041 -6.4649 2.71211 -15 2 1.47071 -0.570933 -1.27771 0.726496 -6.9774 1.88925 -16 1 2.00228 1.05782 -0.124502 -11.1831 12.6873 -1.41281 -17 2 1.14164 1.53227 -0.140121 14.1175 -10.0366 0.774885 -18 2 2.67472 1.73534 -0.237995 -1.81661 -4.28693 0.646829 -ITEM: TIMESTEP -10 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.50519 -0.189085 1.43489 16.1346 -9.03082 7.39643 -2 2 -0.613325 -0.596599 1.55623 -19.7 9.16793 -3.06694 -3 2 -2.00781 -0.423676 2.21968 1.11569 1.33017 -3.51515 -4 1 -1.74545 -0.38218 -1.30921 -0.873137 -0.924011 5.81502 -5 2 -1.86379 -0.472478 -0.34573 -0.592473 0.521176 -9.80595 -6 2 -2.51308 -0.764814 -1.7423 1.95383 0.883641 3.34899 -7 1 -0.566746 2.01551 -0.121884 -0.752908 0.880358 1.51675 -8 2 -0.90288 1.53899 0.653422 -0.370038 -0.282546 -8.72932 -9 2 -0.948386 1.59852 -0.906373 -0.161598 -1.83495 7.27882 -10 1 0.972994 -1.16632 1.4367 2.1365 -3.63541 -4.30666 -11 2 0.921471 -1.54563 0.536978 3.92948 8.96444 9.02535 -12 2 1.51571 -0.366599 1.37318 -3.05971 -5.7155 -5.67471 -13 1 0.973913 -1.39785 -1.33834 -1.44621 0.344209 -0.720777 -14 2 0.0503221 -1.15099 -1.50181 7.085 2.52089 1.36272 -15 2 1.49605 -0.587274 -1.24124 -6.30793 -2.23617 0.0453877 -16 1 2.00301 1.05777 -0.1249 -8.37521 5.68727 -0.0787125 -17 2 1.13805 1.51682 -0.135757 12.8554 -4.94557 -0.27859 -18 2 2.68412 1.72611 -0.2366 -3.57128 -1.69512 0.387339 -ITEM: TIMESTEP -20 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.51053 -0.184679 1.43662 2.59225 -2.34383 2.4228 -2 2 -0.638864 -0.59446 1.56144 -3.81751 1.45077 0.169365 -3 2 -2.02892 -0.415768 2.21112 1.3915 0.960529 -2.2268 -4 1 -1.7422 -0.380161 -1.31156 -2.81538 -1.6524 5.61723 -5 2 -1.87085 -0.467579 -0.355121 2.06181 1.26201 -3.01668 -6 2 -2.51909 -0.769609 -1.71571 1.56589 0.868196 -2.04346 -7 1 -0.571857 2.01726 -0.121524 -4.42229 -10.7497 0.101549 -8 2 -0.894989 1.49275 0.621756 1.9428 5.13739 2.3456 -9 2 -0.928333 1.53949 -0.878364 1.74391 4.55343 -2.63937 -10 1 0.983665 -1.17004 1.43811 2.15858 5.32924 -12.0192 -11 2 0.916986 -1.51176 0.532863 -0.801958 -4.34579 6.00669 -12 2 1.48632 -0.356933 1.30471 -0.115562 -1.35756 5.38685 -13 1 0.974155 -1.39809 -1.34091 -3.6872 9.81415 2.33229 -14 2 0.0608639 -1.11508 -1.47548 0.727822 -4.45373 -1.43277 -15 2 1.45945 -0.57705 -1.18377 2.74992 -3.83937 -1.32423 -16 1 2.0041 1.05318 -0.12468 -4.82863 5.07797 -0.287867 -17 2 1.15863 1.52924 -0.140109 2.7798 -3.05413 0.358119 -18 2 2.67895 1.72504 -0.234758 0.77424 -2.65718 0.249897 -ITEM: TIMESTEP -30 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.5148 -0.180382 1.43888 -14.0787 7.25927 -2.0787 -2 2 -0.670243 -0.596746 1.58256 15.1847 -7.27642 2.26385 -3 2 -2.0578 -0.394757 2.19803 0.335566 -0.184039 0.277588 -4 1 -1.73953 -0.378972 -1.31065 5.17639 2.63373 -5.13987 -5 2 -1.85923 -0.443728 -0.358889 -2.57415 -1.51426 3.86387 -6 2 -2.50599 -0.762479 -1.73443 -2.25678 -0.997735 0.886673 -7 1 -0.57869 2.00716 -0.122116 7.46708 7.5609 -0.932554 -8 2 -0.891326 1.5227 0.646189 -3.77932 -4.24552 -0.379656 -9 2 -0.906489 1.54888 -0.899539 -3.74504 -3.89196 0.775918 -10 1 0.993915 -1.16716 1.4314 -4.03671 -0.827424 10.5116 -11 2 0.932938 -1.58361 0.567361 1.80347 1.36047 -5.88474 -12 2 1.49414 -0.355801 1.3027 1.34198 0.116597 -4.03649 -13 1 0.970608 -1.38983 -1.33905 4.21477 -7.05635 0.421831 -14 2 0.0575618 -1.13428 -1.49637 -1.45416 4.35852 0.0411765 -15 2 1.48422 -0.594211 -1.16216 -2.77696 3.0816 -1.11496 -16 1 2.00096 1.05017 -0.124007 4.94447 -7.97826 1.06585 -17 2 1.17138 1.53183 -0.140668 -5.63771 5.40691 -0.274313 -18 2 2.7082 1.68479 -0.23083 -0.128954 2.19398 -0.267092 -ITEM: TIMESTEP -40 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.5186 -0.17605 1.44225 -24.1552 14.2056 -8.76949 -2 2 -0.687962 -0.594151 1.59127 27.1026 -13.0552 4.45143 -3 2 -2.07116 -0.378379 2.19317 -1.29427 -1.5252 3.96365 -4 1 -1.73305 -0.375414 -1.31137 2.16372 2.0419 -7.75161 -5 2 -1.87951 -0.450834 -0.370226 0.624847 -0.775772 11.2387 -6 2 -2.50254 -0.754697 -1.72909 -2.50645 -1.07375 -3.54713 -7 1 -0.578876 1.99941 -0.124067 2.19183 2.88771 -2.2033 -8 2 -0.936478 1.52242 0.623048 -0.431918 -2.06784 8.93732 -9 2 -0.943689 1.52907 -0.872983 -0.503357 -0.655131 -7.36871 -10 1 1.00066 -1.16525 1.43041 -2.12968 1.37125 11.5778 -11 2 0.974279 -1.60078 0.583019 -3.02955 -6.45349 -11.2722 -12 2 1.51087 -0.375422 1.25067 2.49642 6.22795 1.24643 -13 1 0.96952 -1.38626 -1.33641 3.1199 -1.09706 -1.06644 -14 2 0.0736705 -1.0998 -1.50988 -8.20047 -1.85824 -0.95018 -15 2 1.45433 -0.57243 -1.18601 5.63783 2.37426 1.20997 -16 1 1.9962 1.04317 -0.122075 10.6231 -9.89832 0.540427 -17 2 1.19663 1.55837 -0.138658 -15.3708 7.22601 0.146924 -18 2 2.71508 1.6609 -0.228386 3.66149 2.12531 -0.383549 -ITEM: TIMESTEP -50 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.52326 -0.171807 1.44556 -19.3809 13.2253 -10.6114 -2 2 -0.679923 -0.574818 1.57581 25.4624 -12.0419 4.4477 -3 2 -2.05017 -0.382025 2.20867 -3.53537 -2.33472 6.62258 -4 1 -1.72947 -0.37135 -1.31158 7.45117 4.03521 -12.7525 -5 2 -1.85272 -0.46757 -0.370426 -4.08312 -1.86842 12.0545 -6 2 -2.4914 -0.737252 -1.75485 -4.03109 -2.01148 0.403261 -7 1 -0.581812 1.98886 -0.127591 8.73336 12.0451 -2.23223 -8 2 -0.927295 1.54015 0.641551 -4.26906 -6.45964 5.24049 -9 2 -0.953055 1.5416 -0.887204 -3.28906 -5.2042 -3.24355 -10 1 1.00866 -1.16393 1.43094 -5.76797 0.688141 16.3003 -11 2 0.941718 -1.59751 0.586621 -0.69625 -5.79697 -13.9615 -12 2 1.5005 -0.365594 1.24465 4.16474 6.46538 -1.29083 -13 1 0.968591 -1.37822 -1.33754 5.88173 -13.6635 -0.995409 -14 2 0.058765 -1.13465 -1.50083 -6.65826 5.43105 -0.991523 -15 2 1.47128 -0.574689 -1.20309 0.663977 7.53437 1.14922 -16 1 1.99172 1.03702 -0.120004 11.7209 -15.9347 1.25003 -17 2 1.18616 1.54124 -0.127765 -14.4197 10.6401 -0.950727 -18 2 2.7224 1.64022 -0.223578 2.05256 5.25094 -0.438473 -ITEM: TIMESTEP -60 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.52514 -0.169424 1.44931 -5.6044 5.71407 -7.65735 -2 2 -0.654856 -0.548823 1.55951 12.8877 -6.19997 1.70589 -3 2 -2.01089 -0.399975 2.23335 -4.71544 -1.47688 6.26364 -4 1 -1.72371 -0.366036 -1.3145 0.154709 0.0103655 -5.79078 -5 2 -1.86537 -0.486382 -0.375504 0.204748 0.738589 9.60402 -6 2 -2.49691 -0.728317 -1.74343 -1.12209 -0.453095 -3.27306 -7 1 -0.582396 1.98478 -0.131637 3.0799 3.10149 -1.36944 -8 2 -0.917703 1.51358 0.63199 -1.67497 -1.52591 5.69623 -9 2 -0.95935 1.51373 -0.876424 -0.704912 -1.0485 -4.50039 -10 1 1.01141 -1.16147 1.43332 -7.40944 0.284109 12.5023 -11 2 0.911102 -1.56686 0.573359 1.73368 -3.47737 -10.1102 -12 2 1.49548 -0.352196 1.26684 4.34342 4.22027 -2.29553 -13 1 0.969684 -1.37685 -1.34222 -0.51092 -4.11589 -0.224969 -14 2 0.0587056 -1.1173 -1.48363 -6.15339 -0.904158 -2.27293 -15 2 1.44029 -0.555019 -1.20354 6.44357 4.32801 1.75924 -16 1 1.98854 1.02727 -0.117121 5.38674 -4.81439 0.472007 -17 2 1.17286 1.52668 -0.137432 -10.3716 4.01885 -0.196355 -18 2 2.69 1.66639 -0.213741 4.03261 1.60042 -0.312306 -ITEM: TIMESTEP -70 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.52005 -0.170765 1.45435 7.42813 -0.682132 -3.31568 -2 2 -0.627795 -0.545781 1.54703 -4.484 0.351316 0.767932 -3 2 -1.9938 -0.405389 2.24937 -1.65789 -0.838399 2.61041 -4 1 -1.72181 -0.363627 -1.31513 2.63115 1.26887 -2.8752 -5 2 -1.86247 -0.45623 -0.365408 -2.65258 -1.1368 1.02525 -6 2 -2.4895 -0.712321 -1.77001 -0.898587 -0.369019 2.21573 -7 1 -0.583063 1.97962 -0.135858 1.67055 0.570004 -0.383383 -8 2 -0.908051 1.51128 0.64094 -1.16679 -0.0785678 -0.520586 -9 2 -0.943124 1.49995 -0.888932 -0.754685 -0.199723 0.596245 -10 1 1.00431 -1.15529 1.43647 -0.676345 0.911353 -2.95012 -11 2 0.95109 -1.53365 0.551095 -1.85378 -3.64627 0.0738184 -12 2 1.52689 -0.36229 1.29214 1.34973 2.90443 2.73267 -13 1 0.96764 -1.3732 -1.34735 0.830518 -7.82237 0.0710001 -14 2 0.049796 -1.13062 -1.50565 0.0671147 3.17314 0.120857 -15 2 1.46341 -0.566541 -1.18509 -0.178936 4.65822 -0.507667 -16 1 1.98438 1.02188 -0.114233 -0.881295 -2.57322 0.275288 -17 2 1.13419 1.48172 -0.149659 1.87909 1.86036 0.463365 -18 2 2.6735 1.67987 -0.202074 -0.651386 1.64881 -0.399918 -ITEM: TIMESTEP -80 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.50978 -0.173017 1.45833 15.0482 -9.57345 5.77126 -2 2 -0.617503 -0.581602 1.56045 -17.3455 8.85736 -2.90765 -3 2 -1.99215 -0.403845 2.25671 0.833211 1.42908 -3.53001 -4 1 -1.71857 -0.360372 -1.31644 -7.32338 -2.11362 6.45601 -5 2 -1.89982 -0.440583 -0.365391 4.39327 0.727605 -4.87947 -6 2 -2.49827 -0.701359 -1.75982 2.51785 1.20426 -1.18541 -7 1 -0.581108 1.97455 -0.140769 -3.87733 -3.80002 1.10694 -8 2 -0.928789 1.51932 0.641149 2.19408 2.20718 -5.07369 -9 2 -0.943839 1.48954 -0.89443 1.32563 2.05291 3.72773 -10 1 0.995847 -1.14613 1.43537 0.755936 -5.6909 -0.46639 -11 2 0.966841 -1.55186 0.550806 1.56938 7.42451 5.54707 -12 2 1.55511 -0.362342 1.35836 -2.79165 -2.9995 -5.36768 -13 1 0.967816 -1.37465 -1.35163 -3.29308 4.65803 -0.872226 -14 2 0.0602027 -1.09254 -1.5264 2.56737 -3.64929 1.27094 -15 2 1.45854 -0.559392 -1.19328 1.84002 -1.84978 0.0538636 -16 1 1.98052 1.0158 -0.111184 -7.14388 11.5516 -0.816233 -17 2 1.12003 1.47724 -0.140032 8.70268 -6.85942 1.26876 -18 2 2.64114 1.706 -0.201685 0.0272078 -3.57662 -0.103793 -ITEM: TIMESTEP -90 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.50003 -0.175917 1.46165 15.3898 -11.884 8.8546 -2 2 -0.608584 -0.600731 1.57129 -23.7815 11.9323 -1.75151 -3 2 -2.00991 -0.394435 2.25305 5.57059 1.55514 -7.64598 -4 1 -1.72137 -0.357368 -1.31563 -1.93902 -0.246344 7.85181 -5 2 -1.87234 -0.43987 -0.353482 -0.118832 -0.772284 -11.4834 -6 2 -2.49861 -0.682857 -1.77755 1.48512 0.513779 4.12935 -7 1 -0.579472 1.97061 -0.145894 -8.85759 -8.26094 2.77276 -8 2 -0.945449 1.52054 0.635243 4.66427 4.57627 -6.94972 -9 2 -0.952686 1.48464 -0.897126 3.60343 4.09955 4.74753 -10 1 0.988258 -1.14419 1.44127 11.1074 1.88534 -20.9154 -11 2 0.971991 -1.50516 0.531218 -4.29535 0.162687 14.3489 -12 2 1.5415 -0.356231 1.32305 -5.76468 -4.25266 5.91571 -13 1 0.969416 -1.37359 -1.35605 -1.23717 3.53556 0.174563 -14 2 0.053578 -1.1004 -1.52114 7.10928 -0.236326 1.96556 -15 2 1.49219 -0.569722 -1.21186 -5.0738 -3.24139 -1.5161 -16 1 1.97824 1.01566 -0.108279 -8.95647 8.69277 0.191958 -17 2 1.10027 1.45664 -0.104435 15.9218 -5.21388 -1.22481 -18 2 2.64464 1.70165 -0.21558 -4.82724 -2.84557 0.534172 -ITEM: TIMESTEP -100 -ITEM: NUMBER OF ATOMS -18 -ITEM: BOX BOUNDS ss ss ss --2.5173543550999997e+00 2.6752353550999999e+00 --1.5223951870999999e+00 2.0181841871000001e+00 --1.7341615612999999e+00 2.2202425613000001e+00 -ITEM: ATOMS id type x y z fx fy fz -1 1 -1.4951 -0.17739 1.46185 11.6291 -12.0775 13.5087 -2 2 -0.608426 -0.588808 1.60852 -19.0988 9.4339 -4.86631 -3 2 -2.01619 -0.397996 2.24676 4.77562 3.06476 -9.1756 -4 1 -1.72287 -0.352149 -1.31567 -8.10325 -4.84048 12.8242 -5 2 -1.86729 -0.479262 -0.356777 4.49726 3.58866 -11.0242 -6 2 -2.51926 -0.676876 -1.74282 3.42966 1.20159 -1.20299 -7 1 -0.581355 1.96754 -0.149521 -5.24612 -4.66563 2.71982 -8 2 -0.935394 1.51644 0.636953 2.89489 2.96603 -9.31226 -9 2 -0.942573 1.488 -0.91114 1.96254 2.34604 7.29302 -10 1 0.988651 -1.14425 1.44045 0.840008 -1.36718 -7.83612 -11 2 0.899639 -1.53136 0.543246 5.64911 9.69241 11.7913 -12 2 1.49178 -0.318235 1.33897 -3.7582 -9.86315 -4.79205 -13 1 0.974233 -1.37573 -1.35945 -3.77942 11.331 0.435153 -14 2 0.0583408 -1.08758 -1.49668 6.15796 -3.89994 -0.197074 -15 2 1.48764 -0.558876 -1.24121 -3.14566 -8.24544 0.525665 -16 1 1.97883 1.01496 -0.10404 -9.03485 15.6667 -0.929518 -17 2 1.11471 1.47883 -0.106249 11.9101 -8.77208 -0.858699 -18 2 2.63671 1.70526 -0.232286 -1.57994 -5.55972 1.09694 diff --git a/examples/amoeba/in.ubiquitin b/examples/amoeba/in.ubiquitin index a7f540cc52..205a2430ad 100644 --- a/examples/amoeba/in.ubiquitin +++ b/examples/amoeba/in.ubiquitin @@ -41,8 +41,8 @@ compute virial all pressure NULL virial thermo_style custom step temp epair ebond eangle edihed eimp & emol etotal press c_virial[*] -dump 1 all custom 10 dump.ubiquitin id type x y z fx fy fz -dump_modify 1 sort id +#dump 1 all custom 10 dump.ubiquitin id type x y z fx fy fz +#dump_modify 1 sort id # zero step run diff --git a/examples/amoeba/in.water_box.amoeba b/examples/amoeba/in.water_box.amoeba index 9c46f9d5c8..9963e8926b 100644 --- a/examples/amoeba/in.water_box.amoeba +++ b/examples/amoeba/in.water_box.amoeba @@ -32,8 +32,8 @@ compute virial all pressure NULL virial thermo_style custom step temp epair ebond eangle edihed eimp & emol etotal press c_virial[*] -dump 1 all custom 10 dump.water_box id type x y z fx fy fz -dump_modify 1 sort id +#dump 1 all custom 10 dump.water_box id type x y z fx fy fz +#dump_modify 1 sort id # zero step run diff --git a/examples/amoeba/in.water_box.hippo b/examples/amoeba/in.water_box.hippo index 03d8118eb4..07010960a8 100644 --- a/examples/amoeba/in.water_box.hippo +++ b/examples/amoeba/in.water_box.hippo @@ -32,8 +32,8 @@ compute virial all pressure NULL virial thermo_style custom step temp epair ebond eangle edihed eimp & emol etotal press c_virial[*] -dump 1 all custom 10 dump.water_box id type x y z fx fy fz -dump_modify 1 sort id +#dump 1 all custom 10 dump.water_box id type x y z fx fy fz +#dump_modify 1 sort id # zero step run diff --git a/examples/amoeba/in.water_dimer.amoeba b/examples/amoeba/in.water_dimer.amoeba index 47a2edc193..fb6a83a305 100644 --- a/examples/amoeba/in.water_dimer.amoeba +++ b/examples/amoeba/in.water_dimer.amoeba @@ -32,8 +32,8 @@ compute virial all pressure NULL virial thermo_style custom step temp epair ebond eangle edihed eimp & emol etotal press c_virial[*] -dump 1 all custom 10 dump.water_dimer id type x y z fx fy fz -dump_modify 1 sort id +#dump 1 all custom 10 dump.water_dimer id type x y z fx fy fz +#dump_modify 1 sort id # zero step run diff --git a/examples/amoeba/in.water_dimer.hippo b/examples/amoeba/in.water_dimer.hippo index 21d13512e6..19304c159c 100644 --- a/examples/amoeba/in.water_dimer.hippo +++ b/examples/amoeba/in.water_dimer.hippo @@ -32,8 +32,8 @@ compute virial all pressure NULL virial thermo_style custom step temp epair ebond eangle edihed eimp & emol etotal press c_virial[*] -dump 1 all custom 10 dump.water_dimer id type x y z fx fy fz -dump_modify 1 sort id +#dump 1 all custom 10 dump.water_dimer id type x y z fx fy fz +#dump_modify 1 sort id # zero step run diff --git a/examples/amoeba/in.water_hexamer.amoeba b/examples/amoeba/in.water_hexamer.amoeba index 24211065c9..7fb857b4b8 100644 --- a/examples/amoeba/in.water_hexamer.amoeba +++ b/examples/amoeba/in.water_hexamer.amoeba @@ -32,8 +32,8 @@ compute virial all pressure NULL virial thermo_style custom step temp epair ebond eangle edihed eimp & emol etotal press c_virial[*] -dump 1 all custom 10 dump.water_hexamer id type x y z fx fy fz -dump_modify 1 sort id +#dump 1 all custom 10 dump.water_hexamer id type x y z fx fy fz +#dump_modify 1 sort id # zero step run diff --git a/examples/amoeba/in.water_hexamer.hippo b/examples/amoeba/in.water_hexamer.hippo index c56c938ce8..2de7e3207f 100644 --- a/examples/amoeba/in.water_hexamer.hippo +++ b/examples/amoeba/in.water_hexamer.hippo @@ -32,8 +32,8 @@ compute virial all pressure NULL virial thermo_style custom step temp epair ebond eangle edihed eimp & emol etotal press c_virial[*] -dump 1 all custom 10 dump.water_hexamer id type x y z fx fy fz -dump_modify 1 sort id +#dump 1 all custom 10 dump.water_hexamer id type x y z fx fy fz +#dump_modify 1 sort id # zero step run diff --git a/examples/amoeba/log.5Jul22.ubiquitin.g++.1 b/examples/amoeba/log.5Jul22.ubiquitin.g++.1 new file mode 100644 index 0000000000..fa4a577590 --- /dev/null +++ b/examples/amoeba/log.5Jul22.ubiquitin.g++.1 @@ -0,0 +1,162 @@ +LAMMPS (23 Jun 2022) +OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (src/comm.cpp:98) + using 1 OpenMP thread(s) per MPI task +# solvated ubiquitin molecule with AMOEBA force field + +units real +boundary p p p +atom_modify sort 0 0.0 + +atom_style amoeba + +bond_style class2 +angle_style amoeba +dihedral_style fourier +improper_style amoeba + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 + +fix pit all amoeba/pitorsion +fix_modify pit energy yes +fix bit all amoeba/bitorsion bitorsion.ubiquitin.data +fix_modify bit energy yes + +# read data file + +read_data data.ubiquitin fix amtype NULL "Tinker Types" fix pit "pitorsion types" "PiTorsion Coeffs" fix pit pitorsions PiTorsions fix bit bitorsions BiTorsions +Reading data file ... + orthogonal box = (0 0 0) to (54.99 41.91 41.91) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 9737 atoms + scanning bonds ... + 4 = max bonds/atom + scanning angles ... + 6 = max angles/atom + scanning dihedrals ... + 18 = max dihedrals/atom + scanning impropers ... + 3 = max impropers/atom + reading bonds ... + 6908 bonds + reading angles ... + 5094 angles + reading dihedrals ... + 3297 dihedrals + reading impropers ... + 651 impropers +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 4 = max # of 1-2 neighbors + 9 = max # of 1-3 neighbors + 19 = max # of 1-4 neighbors + 21 = max # of special neighbors + special bonds CPU = 0.003 seconds + read_data CPU = 0.042 seconds + +pair_style amoeba +pair_coeff * * amoeba_ubiquitin.prm amoeba_ubiquitin.key +Skipping section: AMOEBA Protein Force Field Atom Classes +Skipping section: Torsion-Torsion Parameters +Skipping section: Biopolymer Atom Type Conversions + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0.5 0.5 0.5 + special bond factors coul: 0.5 0.5 0.5 + 4 = max # of 1-2 neighbors + 9 = max # of 1-3 neighbors + 19 = max # of 1-4 neighbors + 58 = max # of 1-5 neighbors + 21 = max # of special neighbors + special bonds CPU = 0.004 seconds + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] + +#dump 1 all custom 10 dump.ubiquitin id type x y z fx fy fz +#dump_modify 1 sort id + +# zero step run + +#run 0 + +# dynamics + +fix 1 all nve + +thermo 1 +run 5 +AMOEBA force field settings + hal: cut 12 taper 10.8 vscale 0 0 1 1 + multipole: cut 7 aewald 0.4 bsorder 5 FFT 60 48 48 mscale 0 0 0.4 1 + polar: cut 7 aewald 0.5 bsorder 5 FFT 60 48 48 + pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 1 1 1 1 d/u scale 0 1 + precondition: cut 4.5 +Generated 0 of 15 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 14 + ghost atom cutoff = 14 + binsize = 7, bins = 8 6 6 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair amoeba, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d + bin: standard + AMOEBA group count: 3196 +Per MPI rank memory allocation (min/avg/max) = 258.3 | 258.3 | 258.3 Mbytes + Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] + 0 0 -35338.057 2856.5938 1955.5431 224.37609 65.00809 5101.5211 -30247.585 -6336.5196 -5795.4272 -6329.8149 -6884.3167 349.52657 77.164877 652.41925 + 1 29.61379 -35356.153 2037.3541 1840.7883 223.90217 64.293945 4166.3385 -30341.522 -6486.773 -6452.8463 -6841.5982 -7386.1106 311.38025 120.72605 545.35513 + 2 78.518242 -35383.65 825.39919 1538.3909 222.55095 62.191009 2648.5321 -30467.814 -5502.9841 -6410.2998 -6396.1829 -6937.8137 217.3515 210.76948 294.28051 + 3 88.8921 -35402.11 938.99299 1162.2914 220.5271 58.832521 2380.644 -30453.516 -1929.5417 -3331.1291 -2769.7218 -3350.5733 117.32302 279.72705 31.237776 + 4 68.740402 -35477.589 2048.0659 858.03795 218.14277 54.460022 3178.7066 -30316.325 2041.1138 594.25938 1665.7799 1030.8539 66.230421 304.28296 -155.80224 + 5 76.267862 -35707.869 2206.6534 736.37385 215.75693 49.401674 3208.1859 -30299.377 2276.9276 536.21124 1893.4621 1258.492 92.097191 299.65604 -228.58369 +Loop time of 6.52854 on 1 procs for 5 steps with 9737 atoms + +Performance: 0.066 ns/day, 362.697 hours/ns, 0.766 timesteps/s +99.8% CPU use with 1 MPI tasks x 1 OpenMP threads + +AMOEBA timing breakdown: + Init time: 0.0100839 0.15% + Hal time: 1.54573 23.70% + Mpole time: 0.806911 12.37% + Induce time: 2.63878 40.46% + Polar time: 1.51971 23.30% + Total time: 6.52122 + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 6.5212 | 6.5212 | 6.5212 | 0.0 | 99.89 +Bond | 0.0049597 | 0.0049597 | 0.0049597 | 0.0 | 0.08 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.0010627 | 0.0010627 | 0.0010627 | 0.0 | 0.02 +Output | 0.00032106 | 0.00032106 | 0.00032106 | 0.0 | 0.00 +Modify | 0.00083249 | 0.00083249 | 0.00083249 | 0.0 | 0.01 +Other | | 0.0001265 | | | 0.00 + +Nlocal: 9737 ave 9737 max 9737 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 31511 ave 31511 max 31511 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 5.6393e+06 ave 5.6393e+06 max 5.6393e+06 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 5639296 +Ave neighs/atom = 579.16155 +Ave special neighs/atom = 3.1364897 +Neighbor list builds = 0 +Dangerous builds = 0 +Total wall time: 0:00:08 diff --git a/examples/amoeba/log.5Jul22.ubiquitin.g++.4 b/examples/amoeba/log.5Jul22.ubiquitin.g++.4 new file mode 100644 index 0000000000..057fdb5f82 --- /dev/null +++ b/examples/amoeba/log.5Jul22.ubiquitin.g++.4 @@ -0,0 +1,162 @@ +LAMMPS (23 Jun 2022) +OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (src/comm.cpp:98) + using 1 OpenMP thread(s) per MPI task +# solvated ubiquitin molecule with AMOEBA force field + +units real +boundary p p p +atom_modify sort 0 0.0 + +atom_style amoeba + +bond_style class2 +angle_style amoeba +dihedral_style fourier +improper_style amoeba + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 + +fix pit all amoeba/pitorsion +fix_modify pit energy yes +fix bit all amoeba/bitorsion bitorsion.ubiquitin.data +fix_modify bit energy yes + +# read data file + +read_data data.ubiquitin fix amtype NULL "Tinker Types" fix pit "pitorsion types" "PiTorsion Coeffs" fix pit pitorsions PiTorsions fix bit bitorsions BiTorsions +Reading data file ... + orthogonal box = (0 0 0) to (54.99 41.91 41.91) + 2 by 1 by 2 MPI processor grid + reading atoms ... + 9737 atoms + scanning bonds ... + 4 = max bonds/atom + scanning angles ... + 6 = max angles/atom + scanning dihedrals ... + 18 = max dihedrals/atom + scanning impropers ... + 3 = max impropers/atom + reading bonds ... + 6908 bonds + reading angles ... + 5094 angles + reading dihedrals ... + 3297 dihedrals + reading impropers ... + 651 impropers +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 4 = max # of 1-2 neighbors + 9 = max # of 1-3 neighbors + 19 = max # of 1-4 neighbors + 21 = max # of special neighbors + special bonds CPU = 0.001 seconds + read_data CPU = 0.049 seconds + +pair_style amoeba +pair_coeff * * amoeba_ubiquitin.prm amoeba_ubiquitin.key +Skipping section: AMOEBA Protein Force Field Atom Classes +Skipping section: Torsion-Torsion Parameters +Skipping section: Biopolymer Atom Type Conversions + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0.5 0.5 0.5 + special bond factors coul: 0.5 0.5 0.5 + 4 = max # of 1-2 neighbors + 9 = max # of 1-3 neighbors + 19 = max # of 1-4 neighbors + 58 = max # of 1-5 neighbors + 21 = max # of special neighbors + special bonds CPU = 0.001 seconds + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] + +#dump 1 all custom 10 dump.ubiquitin id type x y z fx fy fz +#dump_modify 1 sort id + +# zero step run + +#run 0 + +# dynamics + +fix 1 all nve + +thermo 1 +run 5 +AMOEBA force field settings + hal: cut 12 taper 10.8 vscale 0 0 1 1 + multipole: cut 7 aewald 0.4 bsorder 5 FFT 60 48 48 mscale 0 0 0.4 1 + polar: cut 7 aewald 0.5 bsorder 5 FFT 60 48 48 + pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 1 1 1 1 d/u scale 0 1 + precondition: cut 4.5 +Generated 0 of 15 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 14 + ghost atom cutoff = 14 + binsize = 7, bins = 8 6 6 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair amoeba, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d + bin: standard + AMOEBA group count: 3196 +Per MPI rank memory allocation (min/avg/max) = 144.2 | 144.7 | 145.4 Mbytes + Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] + 0 0 -35338.057 2856.5938 1955.5431 224.37609 65.00809 5101.5211 -30247.585 -6336.5196 -5795.4272 -6329.8149 -6884.3167 349.52657 77.164877 652.41925 + 1 29.61379 -35356.153 2037.3541 1840.7883 223.90217 64.293945 4166.3385 -30341.522 -6486.773 -6452.8463 -6841.5982 -7386.1106 311.38025 120.72605 545.35513 + 2 78.518242 -35383.65 825.39919 1538.3909 222.55095 62.191009 2648.5321 -30467.814 -5502.9841 -6410.2998 -6396.1829 -6937.8137 217.3515 210.76948 294.28051 + 3 88.8921 -35402.11 938.99299 1162.2914 220.5271 58.832521 2380.644 -30453.516 -1929.5417 -3331.1291 -2769.7218 -3350.5733 117.32302 279.72705 31.237776 + 4 68.740402 -35477.589 2048.0659 858.03795 218.14277 54.460022 3178.7066 -30316.325 2041.1138 594.25938 1665.7799 1030.8539 66.230421 304.28296 -155.80224 + 5 76.267862 -35707.869 2206.6534 736.37385 215.75693 49.401674 3208.1859 -30299.377 2276.9276 536.21124 1893.4621 1258.492 92.097191 299.65604 -228.58369 +Loop time of 2.20325 on 4 procs for 5 steps with 9737 atoms + +Performance: 0.196 ns/day, 122.403 hours/ns, 2.269 timesteps/s +99.1% CPU use with 4 MPI tasks x 1 OpenMP threads + +AMOEBA timing breakdown: + Init time: 0.0117181 0.53% + Hal time: 0.442973 20.14% + Mpole time: 0.287778 13.09% + Induce time: 0.94261 42.86% + Polar time: 0.514081 23.38% + Total time: 2.19916 + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 2.1991 | 2.1992 | 2.1996 | 0.0 | 99.82 +Bond | 0.0011873 | 0.0014547 | 0.0016743 | 0.5 | 0.07 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.0014371 | 0.0018264 | 0.0020772 | 0.6 | 0.08 +Output | 0.0002413 | 0.00029218 | 0.00037812 | 0.0 | 0.01 +Modify | 0.0002694 | 0.00029873 | 0.00032365 | 0.0 | 0.01 +Other | | 0.000135 | | | 0.01 + +Nlocal: 2434.25 ave 2498 max 2390 min +Histogram: 1 1 0 0 1 0 0 0 0 1 +Nghost: 16683.2 ave 16765 max 16568 min +Histogram: 1 0 0 1 0 0 0 0 0 2 +Neighs: 1.40982e+06 ave 1.52088e+06 max 1.30717e+06 min +Histogram: 2 0 0 0 0 0 0 0 1 1 + +Total # of neighbors = 5639296 +Ave neighs/atom = 579.16155 +Ave special neighs/atom = 3.1364897 +Neighbor list builds = 0 +Dangerous builds = 0 +Total wall time: 0:00:02 diff --git a/examples/amoeba/log.5Jul22.water_box.amoeba.g++.1 b/examples/amoeba/log.5Jul22.water_box.amoeba.g++.1 new file mode 100644 index 0000000000..3837b067f7 --- /dev/null +++ b/examples/amoeba/log.5Jul22.water_box.amoeba.g++.1 @@ -0,0 +1,150 @@ +LAMMPS (23 Jun 2022) +OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (src/comm.cpp:98) + using 1 OpenMP thread(s) per MPI task +# replicate water box with AMOEBA or HIPPO + +units real +boundary p p p + +atom_style amoeba +bond_style class2 +angle_style amoeba +dihedral_style none + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 + +# read data file + +read_data data.water_box.amoeba fix amtype NULL "Tinker Types" +Reading data file ... + orthogonal box = (0 0 0) to (18.643 18.643 18.643) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 648 atoms + scanning bonds ... + 2 = max bonds/atom + scanning angles ... + 1 = max angles/atom + reading bonds ... + 432 bonds + reading angles ... + 216 angles +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + read_data CPU = 0.004 seconds + +# force field + +pair_style amoeba +pair_coeff * * amoeba_water.prm amoeba_water_box.key + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0.5 0.5 0.5 + special bond factors coul: 0.5 0.5 0.5 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of 1-5 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] + +#dump 1 all custom 10 dump.water_box id type x y z fx fy fz +#dump_modify 1 sort id + +# zero step run + +#run 0 + +# dynamics + +fix 1 all nve + +thermo 10 +run 100 +AMOEBA force field settings + hal: cut 7 taper 6 vscale 0 0 1 1 + multipole: cut 7 aewald 0.4 bsorder 5 FFT 24 24 24 mscale 0 0 0.4 1 + polar: cut 7 aewald 0.5 bsorder 5 FFT 24 24 24 + pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 1 1 1 1 d/u scale 0 1 + precondition: cut 4.5 +Generated 0 of 1 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 9 + ghost atom cutoff = 9 + binsize = 4.5, bins = 5 5 5 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair amoeba, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d + bin: standard + AMOEBA group count: 216 +Per MPI rank memory allocation (min/avg/max) = 56.94 | 56.94 | 56.94 Mbytes + Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] + 0 0 -2172.0637 166.82637 83.732524 0 0 250.5589 -1921.5048 -6181.4178 -4772.1682 -6954.8414 -6817.2437 -272.19967 3173.3481 2229.9454 + 10 105.50186 -2373.7036 136.67877 106.86833 0 0 243.5471 -1926.6873 -8440.8076 -10450.396 -9513.7369 -9664.6007 -301.7395 322.28511 1917.0314 + 20 143.89822 -2358.363 70.950306 76.775658 0 0 147.72596 -1933.1172 -7370.2083 -7728.5515 -11580.39 -8675.2341 -806.78779 780.67516 2096.34 + 30 157.22465 -2375.4739 50.393531 87.108003 0 0 137.50153 -1934.7514 -4449.577 -6946.7795 -7865.2165 -4954.2358 -417.69587 -1004.2877 -36.388669 + 40 150.92481 -2354.1892 78.482464 53.798462 0 0 132.28093 -1930.8371 353.42948 -939.14353 -4636.5062 475.58057 -1073.8523 -1583.9471 -574.21807 + 50 153.0181 -2388.7322 100.20232 65.813823 0 0 166.01614 -1927.6078 3975.1981 1368.1361 425.64533 3886.0124 -1806.8586 -2534.5272 -2118.2395 + 60 155.01494 -2364.3168 92.946192 44.248949 0 0 137.19514 -1928.1623 5793.7546 3524.7523 1420.4096 6108.7958 -1536.5261 -2558.8204 -1501.5292 + 70 166.70755 -2383.503 76.491199 55.01988 0 0 131.51108 -1930.4824 4744.1583 1919.3954 2838.7666 2669.745 -169.21643 -188.08678 -2256.4142 + 80 171.83506 -2388.0612 76.465932 49.1299 0 0 125.59583 -1931.067 2210.3658 -318.23867 330.74353 -395.26693 -43.142216 252.53012 -1987.0412 + 90 175.73401 -2423.8154 90.786573 63.719496 0 0 154.50607 -1930.3915 -916.91571 -3942.3954 -2566.5361 -3414.8202 199.82369 2365.9443 -266.38604 + 100 173.72684 -2422.367 99.75941 57.294464 0 0 157.05387 -1930.2663 -3585.8356 -5734.1341 -5882.0146 -6232.4353 -227.79935 959.68225 404.47924 +Loop time of 9.20176 on 1 procs for 100 steps with 648 atoms + +Performance: 0.939 ns/day, 25.560 hours/ns, 10.867 timesteps/s +99.8% CPU use with 1 MPI tasks x 1 OpenMP threads + +AMOEBA timing breakdown: + Init time: 0.0197604 0.22% + Hal time: 0.384028 4.18% + Mpole time: 0.939829 10.23% + Induce time: 6.03232 65.64% + Polar time: 1.81401 19.74% + Total time: 9.18998 + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 9.1903 | 9.1903 | 9.1903 | 0.0 | 99.88 +Bond | 0.0024644 | 0.0024644 | 0.0024644 | 0.0 | 0.03 +Neigh | 0.0045623 | 0.0045623 | 0.0045623 | 0.0 | 0.05 +Comm | 0.0024492 | 0.0024492 | 0.0024492 | 0.0 | 0.03 +Output | 0.00046866 | 0.00046866 | 0.00046866 | 0.0 | 0.01 +Modify | 0.00071308 | 0.00071308 | 0.00071308 | 0.0 | 0.01 +Other | | 0.000819 | | | 0.01 + +Nlocal: 648 ave 648 max 648 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 4290 ave 4290 max 4290 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 98545 ave 98545 max 98545 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 98545 +Ave neighs/atom = 152.07562 +Ave special neighs/atom = 2 +Neighbor list builds = 2 +Dangerous builds = 0 +Total wall time: 0:00:09 diff --git a/examples/amoeba/log.5Jul22.water_box.amoeba.g++.4 b/examples/amoeba/log.5Jul22.water_box.amoeba.g++.4 new file mode 100644 index 0000000000..a42f463747 --- /dev/null +++ b/examples/amoeba/log.5Jul22.water_box.amoeba.g++.4 @@ -0,0 +1,150 @@ +LAMMPS (23 Jun 2022) +OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (src/comm.cpp:98) + using 1 OpenMP thread(s) per MPI task +# replicate water box with AMOEBA or HIPPO + +units real +boundary p p p + +atom_style amoeba +bond_style class2 +angle_style amoeba +dihedral_style none + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 + +# read data file + +read_data data.water_box.amoeba fix amtype NULL "Tinker Types" +Reading data file ... + orthogonal box = (0 0 0) to (18.643 18.643 18.643) + 1 by 2 by 2 MPI processor grid + reading atoms ... + 648 atoms + scanning bonds ... + 2 = max bonds/atom + scanning angles ... + 1 = max angles/atom + reading bonds ... + 432 bonds + reading angles ... + 216 angles +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + read_data CPU = 0.004 seconds + +# force field + +pair_style amoeba +pair_coeff * * amoeba_water.prm amoeba_water_box.key + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0.5 0.5 0.5 + special bond factors coul: 0.5 0.5 0.5 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of 1-5 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] + +#dump 1 all custom 10 dump.water_box id type x y z fx fy fz +#dump_modify 1 sort id + +# zero step run + +#run 0 + +# dynamics + +fix 1 all nve + +thermo 10 +run 100 +AMOEBA force field settings + hal: cut 7 taper 6 vscale 0 0 1 1 + multipole: cut 7 aewald 0.4 bsorder 5 FFT 24 24 24 mscale 0 0 0.4 1 + polar: cut 7 aewald 0.5 bsorder 5 FFT 24 24 24 + pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 1 1 1 1 d/u scale 0 1 + precondition: cut 4.5 +Generated 0 of 1 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 9 + ghost atom cutoff = 9 + binsize = 4.5, bins = 5 5 5 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair amoeba, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d + bin: standard + AMOEBA group count: 216 +Per MPI rank memory allocation (min/avg/max) = 56.38 | 56.38 | 56.38 Mbytes + Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] + 0 0 -2172.0637 166.82637 83.732524 0 0 250.5589 -1921.5048 -6181.4178 -4772.1682 -6954.8414 -6817.2437 -272.19967 3173.3481 2229.9454 + 10 105.50186 -2373.7036 136.67877 106.86833 0 0 243.5471 -1926.6873 -8440.8076 -10450.396 -9513.7369 -9664.6007 -301.7395 322.28511 1917.0314 + 20 143.89822 -2358.363 70.950306 76.775658 0 0 147.72596 -1933.1172 -7370.2083 -7728.5515 -11580.39 -8675.2341 -806.78779 780.67516 2096.34 + 30 157.22465 -2375.4739 50.393531 87.108003 0 0 137.50153 -1934.7514 -4449.577 -6946.7795 -7865.2165 -4954.2358 -417.69587 -1004.2877 -36.388669 + 40 150.92481 -2354.1892 78.482464 53.798462 0 0 132.28093 -1930.8371 353.42948 -939.14353 -4636.5062 475.58057 -1073.8523 -1583.9471 -574.21807 + 50 153.0181 -2388.7322 100.20232 65.813823 0 0 166.01614 -1927.6078 3975.1981 1368.1361 425.64533 3886.0124 -1806.8586 -2534.5272 -2118.2395 + 60 155.01494 -2364.3168 92.946192 44.248949 0 0 137.19514 -1928.1623 5793.7546 3524.7523 1420.4096 6108.7958 -1536.5261 -2558.8204 -1501.5292 + 70 166.70755 -2383.503 76.491199 55.01988 0 0 131.51108 -1930.4824 4744.1583 1919.3954 2838.7666 2669.745 -169.21643 -188.08678 -2256.4142 + 80 171.83506 -2388.0612 76.465932 49.1299 0 0 125.59583 -1931.067 2210.3658 -318.23867 330.74353 -395.26693 -43.142216 252.53012 -1987.0412 + 90 175.73401 -2423.8154 90.786573 63.719496 0 0 154.50607 -1930.3915 -916.91571 -3942.3954 -2566.5361 -3414.8202 199.82369 2365.9443 -266.38604 + 100 173.72684 -2422.367 99.75941 57.294464 0 0 157.05387 -1930.2663 -3585.8356 -5734.1341 -5882.0146 -6232.4353 -227.79935 959.68225 404.47924 +Loop time of 3.56288 on 4 procs for 100 steps with 648 atoms + +Performance: 2.425 ns/day, 9.897 hours/ns, 28.067 timesteps/s +99.3% CPU use with 4 MPI tasks x 1 OpenMP threads + +AMOEBA timing breakdown: + Init time: 0.0211994 0.60% + Hal time: 0.112106 3.15% + Mpole time: 0.321265 9.04% + Induce time: 2.48321 69.88% + Polar time: 0.61587 17.33% + Total time: 3.55367 + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 3.5543 | 3.5544 | 3.5544 | 0.0 | 99.76 +Bond | 0.00084867 | 0.0008661 | 0.00088053 | 0.0 | 0.02 +Neigh | 0.0014115 | 0.0014132 | 0.0014157 | 0.0 | 0.04 +Comm | 0.0044654 | 0.0045745 | 0.004671 | 0.1 | 0.13 +Output | 0.00037263 | 0.00042347 | 0.00054242 | 0.0 | 0.01 +Modify | 0.00035262 | 0.00036625 | 0.00037678 | 0.0 | 0.01 +Other | | 0.0008691 | | | 0.02 + +Nlocal: 162 ave 164 max 159 min +Histogram: 1 0 0 0 0 0 1 0 1 1 +Nghost: 2568.5 ave 2585 max 2544 min +Histogram: 1 0 0 0 0 1 0 0 1 1 +Neighs: 24636.2 ave 25226 max 23891 min +Histogram: 1 0 0 0 0 0 2 0 0 1 + +Total # of neighbors = 98545 +Ave neighs/atom = 152.07562 +Ave special neighs/atom = 2 +Neighbor list builds = 2 +Dangerous builds = 0 +Total wall time: 0:00:03 diff --git a/examples/amoeba/log.5Jul22.water_box.hippo.g++.1 b/examples/amoeba/log.5Jul22.water_box.hippo.g++.1 new file mode 100644 index 0000000000..60b16d39c1 --- /dev/null +++ b/examples/amoeba/log.5Jul22.water_box.hippo.g++.1 @@ -0,0 +1,149 @@ +LAMMPS (23 Jun 2022) +OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (src/comm.cpp:98) + using 1 OpenMP thread(s) per MPI task +# water box with AMOEBA or HIPPO + +units real +boundary p p p + +atom_style amoeba +bond_style class2 +angle_style amoeba +dihedral_style none + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 + +# read data file + +read_data data.water_box.hippo fix amtype NULL "Tinker Types" +Reading data file ... + orthogonal box = (0 0 0) to (18.643 18.643 18.643) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 648 atoms + scanning bonds ... + 2 = max bonds/atom + scanning angles ... + 1 = max angles/atom + reading bonds ... + 432 bonds + reading angles ... + 216 angles +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + read_data CPU = 0.004 seconds + +# force field + +pair_style hippo +pair_coeff * * hippo_water.prm hippo_water_box.key + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0.5 0.5 0.5 + special bond factors coul: 0.5 0.5 0.5 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of 1-5 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] + +#dump 1 all custom 10 dump.water_box id type x y z fx fy fz +#dump_modify 1 sort id + +# zero step run + +#run 0 + +# dynamics + +fix 1 all nve + +thermo 1 +run 5 +HIPPO force field settings + repulsion: cut 7 taper 6 rscale 0 0 1 1 + qxfer: cut 7 taper 6 mscale 0 0 0.4 1 + dispersion: cut 7 aewald 0.45 bsorder 4 FFT 16 16 16 dspscale 0 0 0.4 1 + multipole: cut 7 aewald 0.4 bsorder 5 FFT 24 24 24 mscale 0 0 0.4 1 + polar: cut 7 aewald 0.5 bsorder 5 FFT 24 24 24 + pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 0.2 1 1 1 d/u scale 0 1 + precondition: cut 4.5 +Generated 0 of 1 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 9 + ghost atom cutoff = 9 + binsize = 4.5, bins = 5 5 5 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair hippo, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d + bin: standard + HIPPO group count: 216 +Per MPI rank memory allocation (min/avg/max) = 56.46 | 56.46 | 56.46 Mbytes + Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] + 0 0 -2188.594 166.82637 77.478353 0 0 244.30473 -1944.2893 -10859.589 -9285.4645 -11598.049 -11695.254 -282.7072 3164.4148 2495.2578 + 1 29.599499 -2189.0009 110.80903 70.640769 0 0 181.4498 -1950.466 -9781.8027 -8491.8338 -11237.523 -10824.225 -316.85579 2724.3099 2103.706 + 2 77.782401 -2189.0806 26.465487 53.091297 0 0 79.556784 -1959.5139 -5674.5913 -4709.6895 -8454.6227 -7034.3366 -270.02397 1600.8009 1104.5782 + 3 83.751912 -2189.1561 36.936027 32.349803 0 0 69.285831 -1958.3477 1505.3642 2789.4989 -1919.6532 227.71216 3.4467207 240.18575 -91.250567 + 4 59.186129 -2195.3882 116.40559 17.314099 0 0 133.71969 -1947.5231 7666.6109 9441.7634 4355.1915 6787.0543 329.33631 -768.83277 -966.66638 + 5 70.911532 -2215.1422 115.71443 14.75745 0 0 130.47188 -1947.9114 7292.9034 8506.6309 4019.0295 6458.6256 348.80878 -911.32703 -1060.6123 +Loop time of 0.328811 on 1 procs for 5 steps with 648 atoms + +Performance: 1.314 ns/day, 18.267 hours/ns, 15.206 timesteps/s +99.7% CPU use with 1 MPI tasks x 1 OpenMP threads + +HIPPO timing breakdown: + Init time: 0.000849843 0.26% + Repulse time: 0.0386964 11.79% + Disp time: 0.0176955 5.39% + Mpole time: 0.0625716 19.06% + Induce time: 0.122108 37.20% + Polar time: 0.0762897 23.24% + Qxfer time: 0.010031 3.06% + Total time: 0.328242 + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.32826 | 0.32826 | 0.32826 | 0.0 | 99.83 +Bond | 0.00014786 | 0.00014786 | 0.00014786 | 0.0 | 0.04 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 9.3603e-05 | 9.3603e-05 | 9.3603e-05 | 0.0 | 0.03 +Output | 0.00022715 | 0.00022715 | 0.00022715 | 0.0 | 0.07 +Modify | 5.5594e-05 | 5.5594e-05 | 5.5594e-05 | 0.0 | 0.02 +Other | | 2.723e-05 | | | 0.01 + +Nlocal: 648 ave 648 max 648 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 4302 ave 4302 max 4302 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 98585 ave 98585 max 98585 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 98585 +Ave neighs/atom = 152.13735 +Ave special neighs/atom = 2 +Neighbor list builds = 0 +Dangerous builds = 0 +Total wall time: 0:00:00 diff --git a/examples/amoeba/log.5Jul22.water_box.hippo.g++.4 b/examples/amoeba/log.5Jul22.water_box.hippo.g++.4 new file mode 100644 index 0000000000..a17781a2b5 --- /dev/null +++ b/examples/amoeba/log.5Jul22.water_box.hippo.g++.4 @@ -0,0 +1,149 @@ +LAMMPS (23 Jun 2022) +OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (src/comm.cpp:98) + using 1 OpenMP thread(s) per MPI task +# water box with AMOEBA or HIPPO + +units real +boundary p p p + +atom_style amoeba +bond_style class2 +angle_style amoeba +dihedral_style none + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 + +# read data file + +read_data data.water_box.hippo fix amtype NULL "Tinker Types" +Reading data file ... + orthogonal box = (0 0 0) to (18.643 18.643 18.643) + 1 by 2 by 2 MPI processor grid + reading atoms ... + 648 atoms + scanning bonds ... + 2 = max bonds/atom + scanning angles ... + 1 = max angles/atom + reading bonds ... + 432 bonds + reading angles ... + 216 angles +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + read_data CPU = 0.007 seconds + +# force field + +pair_style hippo +pair_coeff * * hippo_water.prm hippo_water_box.key + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0.5 0.5 0.5 + special bond factors coul: 0.5 0.5 0.5 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of 1-5 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] + +#dump 1 all custom 10 dump.water_box id type x y z fx fy fz +#dump_modify 1 sort id + +# zero step run + +#run 0 + +# dynamics + +fix 1 all nve + +thermo 1 +run 5 +HIPPO force field settings + repulsion: cut 7 taper 6 rscale 0 0 1 1 + qxfer: cut 7 taper 6 mscale 0 0 0.4 1 + dispersion: cut 7 aewald 0.45 bsorder 4 FFT 16 16 16 dspscale 0 0 0.4 1 + multipole: cut 7 aewald 0.4 bsorder 5 FFT 24 24 24 mscale 0 0 0.4 1 + polar: cut 7 aewald 0.5 bsorder 5 FFT 24 24 24 + pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 0.2 1 1 1 d/u scale 0 1 + precondition: cut 4.5 +Generated 0 of 1 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 9 + ghost atom cutoff = 9 + binsize = 4.5, bins = 5 5 5 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair hippo, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d + bin: standard + HIPPO group count: 216 +Per MPI rank memory allocation (min/avg/max) = 55.94 | 55.94 | 55.94 Mbytes + Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] + 0 0 -2188.594 166.82637 77.478353 0 0 244.30473 -1944.2893 -10859.589 -9285.4645 -11598.049 -11695.254 -282.7072 3164.4148 2495.2578 + 1 29.599499 -2189.0009 110.80903 70.640769 0 0 181.4498 -1950.466 -9781.8027 -8491.8338 -11237.523 -10824.225 -316.85579 2724.3099 2103.706 + 2 77.782401 -2189.0806 26.465487 53.091297 0 0 79.556784 -1959.5139 -5674.5913 -4709.6895 -8454.6227 -7034.3366 -270.02397 1600.8009 1104.5782 + 3 83.751912 -2189.1561 36.936027 32.349803 0 0 69.285831 -1958.3477 1505.3642 2789.4989 -1919.6532 227.71216 3.4467207 240.18575 -91.250567 + 4 59.186129 -2195.3882 116.40559 17.314099 0 0 133.71969 -1947.5231 7666.6109 9441.7634 4355.1915 6787.0543 329.33631 -768.83277 -966.66638 + 5 70.911532 -2215.1422 115.71443 14.75745 0 0 130.47188 -1947.9114 7292.9034 8506.6309 4019.0295 6458.6256 348.80878 -911.32703 -1060.6123 +Loop time of 0.122174 on 4 procs for 5 steps with 648 atoms + +Performance: 3.536 ns/day, 6.787 hours/ns, 40.925 timesteps/s +98.8% CPU use with 4 MPI tasks x 1 OpenMP threads + +HIPPO timing breakdown: + Init time: 0.00112002 0.93% + Repulse time: 0.0120679 9.97% + Disp time: 0.00648732 5.36% + Mpole time: 0.0211822 17.50% + Induce time: 0.0497719 41.12% + Polar time: 0.0274737 22.70% + Qxfer time: 0.00294446 2.43% + Total time: 0.121048 + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.12105 | 0.12112 | 0.12123 | 0.0 | 99.14 +Bond | 5.27e-05 | 5.9124e-05 | 6.5605e-05 | 0.0 | 0.05 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.00038065 | 0.0005645 | 0.00066198 | 0.0 | 0.46 +Output | 0.00030705 | 0.00035011 | 0.00042646 | 0.0 | 0.29 +Modify | 2.8994e-05 | 3.163e-05 | 3.6394e-05 | 0.0 | 0.03 +Other | | 4.464e-05 | | | 0.04 + +Nlocal: 162 ave 166 max 159 min +Histogram: 2 0 0 0 0 0 0 1 0 1 +Nghost: 2582.75 ave 2600 max 2559 min +Histogram: 1 0 0 1 0 0 0 0 0 2 +Neighs: 24646.2 ave 25106 max 23932 min +Histogram: 1 0 0 0 0 0 1 0 1 1 + +Total # of neighbors = 98585 +Ave neighs/atom = 152.13735 +Ave special neighs/atom = 2 +Neighbor list builds = 0 +Dangerous builds = 0 +Total wall time: 0:00:00 diff --git a/examples/amoeba/log.water_dimer.amoeba.1 b/examples/amoeba/log.5Jul22.water_dimer.amoeba.g++.1 similarity index 50% rename from examples/amoeba/log.water_dimer.amoeba.1 rename to examples/amoeba/log.5Jul22.water_dimer.amoeba.g++.1 index c982de2d9d..f06e3e9380 100644 --- a/examples/amoeba/log.water_dimer.amoeba.1 +++ b/examples/amoeba/log.5Jul22.water_dimer.amoeba.g++.1 @@ -1,4 +1,6 @@ -LAMMPS (24 Mar 2022) +LAMMPS (23 Jun 2022) +OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (src/comm.cpp:98) + using 1 OpenMP thread(s) per MPI task # water dimer with AMOEBA or HIPPO units real @@ -39,7 +41,7 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of special neighbors special bonds CPU = 0.000 seconds - read_data CPU = 0.008 seconds + read_data CPU = 0.003 seconds # force field @@ -63,8 +65,8 @@ compute virial all pressure NULL virial thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] -dump 1 all custom 10 dump.water_dimer id type x y z fx fy fz -dump_modify 1 sort id +#dump 1 all custom 10 dump.water_dimer id type x y z fx fy fz +#dump_modify 1 sort id # zero step run @@ -74,15 +76,15 @@ dump_modify 1 sort id fix 1 all nve -thermo 10 -run 100 -AMOEBA/HIPPO force field settings +thermo 1 +run 5 +AMOEBA force field settings hal: cut 10 taper 8 vscale 0 0 1 1 multipole: cut 10 aewald 0 mscale 0 0 0.4 1 polar: cut 10 aewald 0 pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 1 1 1 1 d/u scale 0 1 precondition: cut 4.5 - generated 0 of 1 mixed pair_coeff terms from geometric mixing rule +Generated 0 of 1 mixed pair_coeff terms from geometric mixing rule Neighbor list info ... update every 1 steps, delay 10 steps, check yes max neighbors/atom: 2000, page size: 100000 @@ -95,44 +97,39 @@ Neighbor list info ... pair build: half/bin/newton stencil: half/bin/3d bin: standard -WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (../domain.cpp:974) - AMOEBA/HIPPO group count: 2 -Per MPI rank memory allocation (min/avg/max) = 49.59 | 49.59 | 49.59 Mbytes +WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (src/domain.cpp:970) + AMOEBA group count: 2 +Per MPI rank memory allocation (min/avg/max) = 48.33 | 48.33 | 48.33 Mbytes Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] 0 0 -5.1627563 0.025695395 0.71581114 0 0 0.74150653 -4.4212497 -12260.522 -43226.042 39448.214 -33003.739 -85.160886 -28101.905 -72.971988 - 10 1.1174766 -4.7928792 0.045080327 0.30848527 0 0 0.35356559 -4.4226587 -14728.416 11456.119 -52592.829 -3262.8454 70.868937 29494.268 57.977562 - 20 3.0821934 -5.1387316 0.013108182 0.65694692 0 0 0.6700551 -4.4227393 3007.4148 -25925.326 49641.41 -15284.933 -79.726771 -29005.234 -68.530079 - 30 3.461967 -4.8079248 0.013888863 0.31895667 0 0 0.33284554 -4.423482 8616.211 40027.877 -31134.295 16291.126 72.510013 23088.238 51.407946 - 40 4.2181367 -5.0535921 0.0099009766 0.55796811 0 0 0.56786908 -4.4228557 24239.885 -5761.6967 62095.735 15576.675 -76.240192 -33057.385 -58.850871 - 50 5.216657 -4.8012751 0.0053003148 0.29489399 0 0 0.30019431 -4.4233315 17728.056 44785.731 -21215.714 28613.715 66.24671 20292.137 51.010856 - 60 9.45101 -5.0818046 0.0043357361 0.5118733 0 0 0.51620903 -4.4247372 16893.135 -15068.961 50111.11 13824.77 -75.966047 -34809.168 -52.83183 - 70 10.385926 -4.8250769 0.022572262 0.22235766 0 0 0.24492992 -4.4253547 -1117.3665 19070.918 -36063.612 11648.813 61.067533 25754.59 53.919881 - 80 12.797691 -5.123735 0.023756795 0.48275385 0 0 0.50651065 -4.4264869 -6491.9826 -28436.037 20681.908 -14176.121 -64.024669 -35737.052 -52.583533 - 90 12.569481 -4.8303379 0.060369422 0.15670502 0 0 0.21707444 -4.4259273 -16762.536 1720.5855 -47624.986 -6793.7441 59.966729 30024.566 52.339671 - 100 17.750788 -5.1195235 0.039885925 0.38711474 0 0 0.42700067 -4.4279642 -10817.92 -21833.456 4186.8301 -18211.329 -43.11086 -32664.671 -41.508916 -Loop time of 0.00655818 on 1 procs for 100 steps with 6 atoms + 1 3.4764991 -5.1500622 0.021865831 0.65347737 0 0 0.67534321 -4.4229051 -8987.9108 -37684.452 39410.243 -29356.236 -80.130511 -27322.706 -69.79235 + 2 12.286735 -5.1147506 0.014370337 0.49051077 0 0 0.50488111 -4.4267474 -865.99299 -23430.467 38420.372 -19944.197 -66.155435 -24835.896 -60.583907 + 3 22.599529 -5.0641035 0.0093422156 0.28736734 0 0 0.29670956 -4.4305695 7832.024 -6436.638 34275.274 -8676.6339 -46.038158 -20245.105 -46.202354 + 4 30.447598 -5.0072832 0.0076827791 0.11282886 0 0 0.12051164 -4.432979 12374.854 6652.5061 24658.364 -25.4576 -23.025707 -13137.295 -27.801932 + 5 33.189086 -4.9523094 0.0086012541 0.015399005 0 0 0.024000259 -4.4336573 10023.674 11810.883 8754.5769 3140.658 0.25267021 -3546.6216 -6.83205 +Loop time of 0.000286908 on 1 procs for 5 steps with 6 atoms -Performance: 1317.439 ns/day, 0.018 hours/ns, 15248.138 timesteps/s -98.5% CPU use with 1 MPI tasks x no OpenMP threads +Performance: 1505.709 ns/day, 0.016 hours/ns, 17427.189 timesteps/s +98.6% CPU use with 1 MPI tasks x 1 OpenMP threads -AMEOBA/HIPPO timing breakdown: - Init time: 0.000126483 0.0233682 - Hal time: 0.000471055 8.70292 - Mpole time: 0.000619314 11.4421 - Induce time: 0.00270856 50.0417 - Polar time: 0.00147122 27.1814 - Total time: 0.00541261 +AMOEBA timing breakdown: + Init time: 7.417e-06 4.75% + Hal time: 8.458e-06 5.42% + Mpole time: 2.2734e-05 14.57% + Induce time: 7.4016e-05 47.43% + Polar time: 4.2972e-05 27.54% + Total time: 0.00015604 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.005443 | 0.005443 | 0.005443 | 0.0 | 83.00 -Bond | 9.6579e-05 | 9.6579e-05 | 9.6579e-05 | 0.0 | 1.47 +Pair | 0.00015922 | 0.00015922 | 0.00015922 | 0.0 | 55.49 +Bond | 5.034e-06 | 5.034e-06 | 5.034e-06 | 0.0 | 1.75 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 1.7434e-05 | 1.7434e-05 | 1.7434e-05 | 0.0 | 0.27 -Output | 0.0008951 | 0.0008951 | 0.0008951 | 0.0 | 13.65 -Modify | 5.161e-05 | 5.161e-05 | 5.161e-05 | 0.0 | 0.79 -Other | | 5.444e-05 | | | 0.83 +Comm | 8.49e-07 | 8.49e-07 | 8.49e-07 | 0.0 | 0.30 +Output | 0.00011336 | 0.00011336 | 0.00011336 | 0.0 | 39.51 +Modify | 2.093e-06 | 2.093e-06 | 2.093e-06 | 0.0 | 0.73 +Other | | 6.355e-06 | | | 2.21 Nlocal: 6 ave 6 max 6 min Histogram: 1 0 0 0 0 0 0 0 0 0 diff --git a/examples/amoeba/log.water_dimer.amoeba.4 b/examples/amoeba/log.5Jul22.water_dimer.amoeba.g++.4 similarity index 50% rename from examples/amoeba/log.water_dimer.amoeba.4 rename to examples/amoeba/log.5Jul22.water_dimer.amoeba.g++.4 index 026fcfdbcc..285d3512bf 100644 --- a/examples/amoeba/log.water_dimer.amoeba.4 +++ b/examples/amoeba/log.5Jul22.water_dimer.amoeba.g++.4 @@ -1,4 +1,6 @@ -LAMMPS (24 Mar 2022) +LAMMPS (23 Jun 2022) +OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (src/comm.cpp:98) + using 1 OpenMP thread(s) per MPI task # water dimer with AMOEBA or HIPPO units real @@ -39,7 +41,7 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of special neighbors special bonds CPU = 0.000 seconds - read_data CPU = 0.009 seconds + read_data CPU = 0.004 seconds # force field @@ -63,8 +65,8 @@ compute virial all pressure NULL virial thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] -dump 1 all custom 10 dump.water_dimer id type x y z fx fy fz -dump_modify 1 sort id +#dump 1 all custom 10 dump.water_dimer id type x y z fx fy fz +#dump_modify 1 sort id # zero step run @@ -74,15 +76,15 @@ dump_modify 1 sort id fix 1 all nve -thermo 10 -run 100 -AMOEBA/HIPPO force field settings +thermo 1 +run 5 +AMOEBA force field settings hal: cut 10 taper 8 vscale 0 0 1 1 multipole: cut 10 aewald 0 mscale 0 0 0.4 1 polar: cut 10 aewald 0 pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 1 1 1 1 d/u scale 0 1 precondition: cut 4.5 - generated 0 of 1 mixed pair_coeff terms from geometric mixing rule +Generated 0 of 1 mixed pair_coeff terms from geometric mixing rule Neighbor list info ... update every 1 steps, delay 10 steps, check yes max neighbors/atom: 2000, page size: 100000 @@ -95,44 +97,39 @@ Neighbor list info ... pair build: half/bin/newton stencil: half/bin/3d bin: standard -WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (../domain.cpp:974) - AMOEBA/HIPPO group count: 2 -Per MPI rank memory allocation (min/avg/max) = 49.61 | 49.75 | 49.88 Mbytes +WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (src/domain.cpp:970) + AMOEBA group count: 2 +Per MPI rank memory allocation (min/avg/max) = 48.35 | 48.48 | 48.62 Mbytes Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] 0 0 -5.1627563 0.025695395 0.71581114 0 0 0.74150653 -4.4212497 -12260.522 -43226.042 39448.214 -33003.739 -85.160886 -28101.905 -72.971988 - 10 1.1174766 -4.7928792 0.045080327 0.30848527 0 0 0.35356559 -4.4226587 -14728.416 11456.119 -52592.829 -3262.8454 70.868937 29494.268 57.977562 - 20 3.0821934 -5.1387316 0.013108182 0.65694692 0 0 0.6700551 -4.4227393 3007.4148 -25925.326 49641.41 -15284.933 -79.726771 -29005.234 -68.530079 - 30 3.461967 -4.8079248 0.013888863 0.31895667 0 0 0.33284554 -4.423482 8616.211 40027.877 -31134.295 16291.126 72.510013 23088.238 51.407946 - 40 4.2181367 -5.0535921 0.0099009766 0.55796811 0 0 0.56786908 -4.4228557 24239.885 -5761.6967 62095.735 15576.675 -76.240192 -33057.385 -58.850871 - 50 5.216657 -4.8012751 0.0053003148 0.29489399 0 0 0.30019431 -4.4233315 17728.056 44785.731 -21215.714 28613.715 66.24671 20292.137 51.010856 - 60 9.45101 -5.0818046 0.0043357361 0.5118733 0 0 0.51620903 -4.4247372 16893.135 -15068.961 50111.11 13824.77 -75.966047 -34809.168 -52.83183 - 70 10.385926 -4.8250769 0.022572262 0.22235766 0 0 0.24492992 -4.4253547 -1117.3665 19070.918 -36063.612 11648.813 61.067533 25754.59 53.919881 - 80 12.797691 -5.123735 0.023756795 0.48275385 0 0 0.50651065 -4.4264869 -6491.9826 -28436.037 20681.908 -14176.121 -64.024669 -35737.052 -52.583533 - 90 12.569481 -4.8303379 0.060369422 0.15670502 0 0 0.21707444 -4.4259273 -16762.536 1720.5855 -47624.986 -6793.7441 59.966729 30024.566 52.339671 - 100 17.750788 -5.1195235 0.039885925 0.38711474 0 0 0.42700067 -4.4279642 -10817.92 -21833.456 4186.8301 -18211.329 -43.11086 -32664.671 -41.508916 -Loop time of 0.0167554 on 4 procs for 100 steps with 6 atoms + 1 3.4764991 -5.1500622 0.021865831 0.65347737 0 0 0.67534321 -4.4229051 -8987.9108 -37684.452 39410.243 -29356.236 -80.130511 -27322.706 -69.79235 + 2 12.286735 -5.1147506 0.014370337 0.49051077 0 0 0.50488111 -4.4267474 -865.99299 -23430.467 38420.372 -19944.197 -66.155435 -24835.896 -60.583907 + 3 22.599529 -5.0641035 0.0093422156 0.28736734 0 0 0.29670956 -4.4305695 7832.024 -6436.638 34275.274 -8676.6339 -46.038158 -20245.105 -46.202354 + 4 30.447598 -5.0072832 0.0076827791 0.11282886 0 0 0.12051164 -4.432979 12374.854 6652.5061 24658.364 -25.4576 -23.025707 -13137.295 -27.801932 + 5 33.189086 -4.9523094 0.0086012541 0.015399005 0 0 0.024000259 -4.4336573 10023.674 11810.883 8754.5769 3140.658 0.25267021 -3546.6216 -6.83205 +Loop time of 0.000582267 on 4 procs for 5 steps with 6 atoms -Performance: 515.654 ns/day, 0.047 hours/ns, 5968.213 timesteps/s -99.4% CPU use with 4 MPI tasks x no OpenMP threads +Performance: 741.928 ns/day, 0.032 hours/ns, 8587.130 timesteps/s +99.5% CPU use with 4 MPI tasks x 1 OpenMP threads -AMEOBA/HIPPO timing breakdown: - Init time: 0.000555846 0.0390251 - Hal time: 0.000129733 0.910835 - Mpole time: 0.000783914 5.50375 - Induce time: 0.0115771 81.2811 - Polar time: 0.00118294 8.30522 - Total time: 0.0142433 +AMOEBA timing breakdown: + Init time: 1.3264e-05 3.71% + Hal time: 3.16275e-06 0.88% + Mpole time: 2.35955e-05 6.60% + Induce time: 0.000290896 81.33% + Polar time: 2.62723e-05 7.34% + Total time: 0.000357696 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.013911 | 0.014439 | 0.0147 | 0.3 | 86.18 -Bond | 1.196e-05 | 4.4667e-05 | 8.5848e-05 | 0.0 | 0.27 +Pair | 0.00036015 | 0.00038587 | 0.00040555 | 0.0 | 66.27 +Bond | 1.441e-06 | 3.3365e-06 | 5.265e-06 | 0.0 | 0.57 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.00060682 | 0.00082002 | 0.001342 | 0.0 | 4.89 -Output | 0.00098235 | 0.0010281 | 0.0011458 | 0.2 | 6.14 -Modify | 2.2946e-05 | 3.473e-05 | 4.2983e-05 | 0.0 | 0.21 -Other | | 0.0003885 | | | 2.32 +Comm | 2.1512e-05 | 3.3761e-05 | 4.9368e-05 | 0.0 | 5.80 +Output | 0.00012269 | 0.00014666 | 0.00017989 | 0.0 | 25.19 +Modify | 1.659e-06 | 2.0448e-06 | 2.275e-06 | 0.0 | 0.35 +Other | | 1.059e-05 | | | 1.82 Nlocal: 1.5 ave 3 max 0 min Histogram: 2 0 0 0 0 0 0 0 0 2 diff --git a/examples/amoeba/log.water_dimer.hippo.1 b/examples/amoeba/log.5Jul22.water_dimer.hippo.g++.1 similarity index 50% rename from examples/amoeba/log.water_dimer.hippo.1 rename to examples/amoeba/log.5Jul22.water_dimer.hippo.g++.1 index 7ec0d856e7..1248c00290 100644 --- a/examples/amoeba/log.water_dimer.hippo.1 +++ b/examples/amoeba/log.5Jul22.water_dimer.hippo.g++.1 @@ -1,4 +1,6 @@ -LAMMPS (24 Mar 2022) +LAMMPS (23 Jun 2022) +OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (src/comm.cpp:98) + using 1 OpenMP thread(s) per MPI task # water dimer with AMOEBA or HIPPO units real @@ -39,7 +41,7 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of special neighbors special bonds CPU = 0.000 seconds - read_data CPU = 0.008 seconds + read_data CPU = 0.003 seconds # force field @@ -63,8 +65,8 @@ compute virial all pressure NULL virial thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] -dump 1 all custom 10 dump.water_dimer id type x y z fx fy fz -dump_modify 1 sort id +#dump 1 all custom 10 dump.water_dimer id type x y z fx fy fz +#dump_modify 1 sort id # zero step run @@ -74,9 +76,9 @@ dump_modify 1 sort id fix 1 all nve -thermo 10 -run 100 -AMOEBA/HIPPO force field settings +thermo 1 +run 5 +HIPPO force field settings repulsion: cut 10 taper 8 rscale 0 0 1 1 qxfer: cut 10 taper 8 mscale 0 0 0.4 1 dispersion: cut 10 aewald 0 dspscale 0 0 0.4 1 @@ -84,7 +86,7 @@ AMOEBA/HIPPO force field settings polar: cut 10 aewald 0 pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 0.2 1 1 1 d/u scale 0 1 precondition: cut 4.5 - generated 0 of 1 mixed pair_coeff terms from geometric mixing rule +Generated 0 of 1 mixed pair_coeff terms from geometric mixing rule Neighbor list info ... update every 1 steps, delay 10 steps, check yes max neighbors/atom: 2000, page size: 100000 @@ -97,46 +99,41 @@ Neighbor list info ... pair build: half/bin/newton stencil: half/bin/3d bin: standard -WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (../domain.cpp:974) - AMOEBA/HIPPO group count: 2 -Per MPI rank memory allocation (min/avg/max) = 49.15 | 49.15 | 49.15 Mbytes +WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (src/domain.cpp:970) + HIPPO group count: 2 +Per MPI rank memory allocation (min/avg/max) = 47.9 | 47.9 | 47.9 Mbytes Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] 0 0 -5.0101954 0.025695395 0.51472748 0 0 0.54042288 -4.4697726 -11875.159 -38149.178 29162.678 -26638.977 -70.63422 -24614.614 -58.505595 - 10 0.75132894 -4.7952077 0.028216017 0.28494196 0 0 0.31315798 -4.4708519 -13243.822 12661.254 -49613.657 -2923.1497 69.449413 29456.684 56.087663 - 20 2.1716525 -5.0036265 0.011809223 0.48875837 0 0 0.50056759 -4.4706925 4371.5298 -22102.532 47044.297 -12243.648 -74.588915 -28903.762 -64.48154 - 30 2.9930198 -4.8261906 0.0091463366 0.30162756 0 0 0.3107739 -4.4708086 9992.4549 41973.539 -20985.339 8415.1715 67.458145 25027.414 40.261795 - 40 3.312268 -4.9802484 0.010400667 0.45076258 0 0 0.46116325 -4.4697189 21565.307 -11602.414 65186.215 10476.902 -83.374203 -33222.094 -64.700001 - 50 4.3187397 -4.8535614 0.0060313545 0.31244652 0 0 0.31847788 -4.4707168 11344.244 45839.35 -21073.749 8438.8954 73.345039 29422.636 43.897876 - 60 4.9127902 -5.0035271 0.0070589202 0.45246538 0 0 0.4595243 -4.4707824 6529.9354 -37107.891 46740.24 9015.2973 -90.41111 -34402.095 -53.57079 - 70 5.3145827 -4.8748857 0.025797484 0.29875503 0 0 0.32455252 -4.4711244 -10208.876 26324.134 -49272.688 -8697.2875 84.479942 36185.667 57.000355 - 80 3.8409793 -5.0262066 0.027669388 0.47104466 0 0 0.49871405 -4.4702464 -9777.1809 -52088.554 28053.855 -6033.4555 -94.607853 -44638.417 -59.108505 - 90 3.0683704 -4.8369716 0.035455716 0.28466932 0 0 0.32012503 -4.4711155 -10626.245 31066.635 -49425.925 -14107.889 87.765958 34632.905 52.101981 - 100 3.5262799 -4.9906817 0.016687539 0.45011301 0 0 0.46680055 -4.4713252 5216.7691 -34991.221 43883.163 6082.1058 -95.830393 -48645.129 -64.784334 -Loop time of 0.00568827 on 1 procs for 100 steps with 6 atoms + 1 2.8239917 -5.0023563 0.021919009 0.46718 0 0 0.48909901 -4.4711684 -8777.4654 -33285.75 30332.24 -23920.463 -67.159404 -23940.605 -56.913519 + 2 9.9359188 -4.9806071 0.014704278 0.34344685 0 0 0.35815113 -4.4743705 -1094.2989 -20777.766 32507.918 -16918.53 -57.217298 -21702.479 -51.827962 + 3 18.15288 -4.9496234 0.010334146 0.19125791 0 0 0.20159205 -4.47748 7115.3453 -5853.149 32274.916 -8557.0355 -41.982111 -17374.865 -42.455978 + 4 24.248994 -4.9153331 0.0093063079 0.065238074 0 0 0.074544382 -4.4793805 11356.801 5716.9586 25838.412 -2135.3667 -22.820662 -10495.224 -28.045156 + 5 26.136423 -4.8829114 0.0095061937 0.0039834608 0 0 0.013489654 -4.4798832 9044.3732 10498.874 11345.536 276.34491 -1.1467483 -1185.8556 -8.820154 +Loop time of 0.000211279 on 1 procs for 5 steps with 6 atoms -Performance: 1518.916 ns/day, 0.016 hours/ns, 17580.041 timesteps/s -76.9% CPU use with 1 MPI tasks x no OpenMP threads +Performance: 2044.690 ns/day, 0.012 hours/ns, 23665.390 timesteps/s +98.4% CPU use with 1 MPI tasks x 1 OpenMP threads -AMEOBA/HIPPO timing breakdown: - Init time: 0.00011293 0.024348 - Repulse time: 0.000604058 13.0236 - Disp time: 0.000336908 7.26382 - Mpole time: 0.000853828 18.4087 - Induce time: 0.00158723 34.2211 - Polar time: 0.000996193 21.4782 - Qxfer time: 0.000142246 3.06686 - Total time: 0.00463817 +HIPPO timing breakdown: + Init time: 4.768e-06 4.20% + Repulse time: 1.3408e-05 11.81% + Disp time: 9.476e-06 8.35% + Mpole time: 2.1547e-05 18.98% + Induce time: 3.7631e-05 33.14% + Polar time: 2.4333e-05 21.43% + Qxfer time: 2.244e-06 1.98% + Total time: 0.000113542 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.0046663 | 0.0046663 | 0.0046663 | 0.0 | 82.03 -Bond | 7.8168e-05 | 7.8168e-05 | 7.8168e-05 | 0.0 | 1.37 +Pair | 0.00011535 | 0.00011535 | 0.00011535 | 0.0 | 54.60 +Bond | 3.239e-06 | 3.239e-06 | 3.239e-06 | 0.0 | 1.53 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 1.3206e-05 | 1.3206e-05 | 1.3206e-05 | 0.0 | 0.23 -Output | 0.00084402 | 0.00084402 | 0.00084402 | 0.0 | 14.84 -Modify | 3.8896e-05 | 3.8896e-05 | 3.8896e-05 | 0.0 | 0.68 -Other | | 4.77e-05 | | | 0.84 +Comm | 6.41e-07 | 6.41e-07 | 6.41e-07 | 0.0 | 0.30 +Output | 8.5752e-05 | 8.5752e-05 | 8.5752e-05 | 0.0 | 40.59 +Modify | 1.55e-06 | 1.55e-06 | 1.55e-06 | 0.0 | 0.73 +Other | | 4.744e-06 | | | 2.25 Nlocal: 6 ave 6 max 6 min Histogram: 1 0 0 0 0 0 0 0 0 0 diff --git a/examples/amoeba/log.water_dimer.hippo.4 b/examples/amoeba/log.5Jul22.water_dimer.hippo.g++.4 similarity index 51% rename from examples/amoeba/log.water_dimer.hippo.4 rename to examples/amoeba/log.5Jul22.water_dimer.hippo.g++.4 index cd0767ae54..f25f4bed91 100644 --- a/examples/amoeba/log.water_dimer.hippo.4 +++ b/examples/amoeba/log.5Jul22.water_dimer.hippo.g++.4 @@ -1,4 +1,6 @@ -LAMMPS (24 Mar 2022) +LAMMPS (23 Jun 2022) +OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (src/comm.cpp:98) + using 1 OpenMP thread(s) per MPI task # water dimer with AMOEBA or HIPPO units real @@ -39,7 +41,7 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of special neighbors special bonds CPU = 0.000 seconds - read_data CPU = 0.009 seconds + read_data CPU = 0.004 seconds # force field @@ -55,7 +57,7 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of 1-5 neighbors 2 = max # of special neighbors - special bonds CPU = 0.001 seconds + special bonds CPU = 0.000 seconds # thermo output @@ -63,8 +65,8 @@ compute virial all pressure NULL virial thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] -dump 1 all custom 10 dump.water_dimer id type x y z fx fy fz -dump_modify 1 sort id +#dump 1 all custom 10 dump.water_dimer id type x y z fx fy fz +#dump_modify 1 sort id # zero step run @@ -74,9 +76,9 @@ dump_modify 1 sort id fix 1 all nve -thermo 10 -run 100 -AMOEBA/HIPPO force field settings +thermo 1 +run 5 +HIPPO force field settings repulsion: cut 10 taper 8 rscale 0 0 1 1 qxfer: cut 10 taper 8 mscale 0 0 0.4 1 dispersion: cut 10 aewald 0 dspscale 0 0 0.4 1 @@ -84,7 +86,7 @@ AMOEBA/HIPPO force field settings polar: cut 10 aewald 0 pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 0.2 1 1 1 d/u scale 0 1 precondition: cut 4.5 - generated 0 of 1 mixed pair_coeff terms from geometric mixing rule +Generated 0 of 1 mixed pair_coeff terms from geometric mixing rule Neighbor list info ... update every 1 steps, delay 10 steps, check yes max neighbors/atom: 2000, page size: 100000 @@ -97,46 +99,41 @@ Neighbor list info ... pair build: half/bin/newton stencil: half/bin/3d bin: standard -WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (../domain.cpp:974) - AMOEBA/HIPPO group count: 2 -Per MPI rank memory allocation (min/avg/max) = 49.18 | 49.31 | 49.44 Mbytes +WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (src/domain.cpp:970) + HIPPO group count: 2 +Per MPI rank memory allocation (min/avg/max) = 47.91 | 48.04 | 48.18 Mbytes Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] 0 0 -5.0101954 0.025695395 0.51472748 0 0 0.54042288 -4.4697726 -11875.159 -38149.178 29162.678 -26638.977 -70.63422 -24614.614 -58.505595 - 10 0.75132894 -4.7952077 0.028216017 0.28494196 0 0 0.31315798 -4.4708519 -13243.822 12661.254 -49613.657 -2923.1497 69.449413 29456.684 56.087663 - 20 2.1716525 -5.0036265 0.011809223 0.48875837 0 0 0.50056759 -4.4706925 4371.5298 -22102.532 47044.297 -12243.648 -74.588915 -28903.762 -64.48154 - 30 2.9930198 -4.8261906 0.0091463366 0.30162756 0 0 0.3107739 -4.4708086 9992.4549 41973.539 -20985.339 8415.1715 67.458145 25027.414 40.261795 - 40 3.312268 -4.9802484 0.010400667 0.45076258 0 0 0.46116325 -4.4697189 21565.307 -11602.414 65186.215 10476.902 -83.374203 -33222.094 -64.700001 - 50 4.3187397 -4.8535614 0.0060313545 0.31244652 0 0 0.31847788 -4.4707168 11344.244 45839.35 -21073.749 8438.8954 73.345039 29422.636 43.897876 - 60 4.9127902 -5.0035271 0.0070589202 0.45246538 0 0 0.4595243 -4.4707824 6529.9354 -37107.891 46740.24 9015.2973 -90.41111 -34402.095 -53.57079 - 70 5.3145827 -4.8748857 0.025797484 0.29875503 0 0 0.32455252 -4.4711244 -10208.876 26324.134 -49272.688 -8697.2875 84.479942 36185.667 57.000355 - 80 3.8409793 -5.0262066 0.027669388 0.47104466 0 0 0.49871405 -4.4702464 -9777.1809 -52088.554 28053.855 -6033.4555 -94.607853 -44638.417 -59.108505 - 90 3.0683704 -4.8369716 0.035455716 0.28466932 0 0 0.32012503 -4.4711155 -10626.245 31066.635 -49425.925 -14107.889 87.765958 34632.905 52.101981 - 100 3.5262799 -4.9906817 0.016687539 0.45011301 0 0 0.46680055 -4.4713252 5216.7691 -34991.221 43883.163 6082.1058 -95.830393 -48645.129 -64.784334 -Loop time of 0.0133873 on 4 procs for 100 steps with 6 atoms + 1 2.8239917 -5.0023563 0.021919009 0.46718 0 0 0.48909901 -4.4711684 -8777.4654 -33285.75 30332.24 -23920.463 -67.159404 -23940.605 -56.913519 + 2 9.9359188 -4.9806071 0.014704278 0.34344685 0 0 0.35815113 -4.4743705 -1094.2989 -20777.766 32507.918 -16918.53 -57.217298 -21702.479 -51.827962 + 3 18.15288 -4.9496234 0.010334146 0.19125791 0 0 0.20159205 -4.47748 7115.3453 -5853.149 32274.916 -8557.0355 -41.982111 -17374.865 -42.455978 + 4 24.248994 -4.9153331 0.0093063079 0.065238074 0 0 0.074544382 -4.4793805 11356.801 5716.9586 25838.412 -2135.3667 -22.820662 -10495.224 -28.045156 + 5 26.136423 -4.8829114 0.0095061937 0.0039834608 0 0 0.013489654 -4.4798832 9044.3732 10498.874 11345.536 276.34491 -1.1467483 -1185.8556 -8.820154 +Loop time of 0.000515971 on 4 procs for 5 steps with 6 atoms -Performance: 645.386 ns/day, 0.037 hours/ns, 7469.744 timesteps/s -98.4% CPU use with 4 MPI tasks x no OpenMP threads +Performance: 837.257 ns/day, 0.029 hours/ns, 9690.472 timesteps/s +99.1% CPU use with 4 MPI tasks x 1 OpenMP threads -AMEOBA/HIPPO timing breakdown: - Init time: 0.000581606 0.0545512 - Repulse time: 0.000622984 5.84322 - Disp time: 0.000115637 1.0846 - Mpole time: 0.000994723 9.32991 - Induce time: 0.00737161 69.1413 - Polar time: 0.00091816 8.61179 - Qxfer time: 5.1997e-05 0.487701 - Total time: 0.0106617 +HIPPO timing breakdown: + Init time: 1.26765e-05 4.09% + Repulse time: 1.99082e-05 6.43% + Disp time: 3.16825e-06 1.02% + Mpole time: 3.4956e-05 11.29% + Induce time: 0.000205268 66.29% + Polar time: 3.1924e-05 10.31% + Qxfer time: 1.5545e-06 0.50% + Total time: 0.000309632 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.010579 | 0.010896 | 0.011085 | 0.2 | 81.39 -Bond | 1.3578e-05 | 4.3855e-05 | 7.6592e-05 | 0.0 | 0.33 +Pair | 0.0003033 | 0.00032943 | 0.00034747 | 0.0 | 63.85 +Bond | 1.237e-06 | 2.778e-06 | 4.775e-06 | 0.0 | 0.54 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.00058533 | 0.00080957 | 0.0011064 | 0.0 | 6.05 -Output | 0.0011175 | 0.0011761 | 0.0013051 | 0.2 | 8.78 -Modify | 2.4304e-05 | 3.4805e-05 | 4.2149e-05 | 0.0 | 0.26 -Other | | 0.0004266 | | | 3.19 +Comm | 1.2356e-05 | 3.1848e-05 | 4.3553e-05 | 0.0 | 6.17 +Output | 0.00012443 | 0.0001412 | 0.00015698 | 0.0 | 27.37 +Modify | 1.428e-06 | 2.0447e-06 | 2.545e-06 | 0.0 | 0.40 +Other | | 8.678e-06 | | | 1.68 Nlocal: 1.5 ave 3 max 0 min Histogram: 2 0 0 0 0 0 0 0 0 2 diff --git a/examples/amoeba/log.water_hexamer.amoeba.1 b/examples/amoeba/log.5Jul22.water_hexamer.amoeba.g++.1 similarity index 50% rename from examples/amoeba/log.water_hexamer.amoeba.1 rename to examples/amoeba/log.5Jul22.water_hexamer.amoeba.g++.1 index 5cfdcf9338..9182a054c6 100644 --- a/examples/amoeba/log.water_hexamer.amoeba.1 +++ b/examples/amoeba/log.5Jul22.water_hexamer.amoeba.g++.1 @@ -1,4 +1,6 @@ -LAMMPS (24 Mar 2022) +LAMMPS (23 Jun 2022) +OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (src/comm.cpp:98) + using 1 OpenMP thread(s) per MPI task # water hexamer with AMOEBA or HIPPO units real @@ -39,7 +41,7 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of special neighbors special bonds CPU = 0.000 seconds - read_data CPU = 0.009 seconds + read_data CPU = 0.003 seconds # force field @@ -63,8 +65,8 @@ compute virial all pressure NULL virial thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] -dump 1 all custom 10 dump.water_hexamer id type x y z fx fy fz -dump_modify 1 sort id +#dump 1 all custom 10 dump.water_hexamer id type x y z fx fy fz +#dump_modify 1 sort id # zero step run @@ -74,15 +76,15 @@ dump_modify 1 sort id fix 1 all nve -thermo 10 -run 100 -AMOEBA/HIPPO force field settings +thermo 1 +run 5 +AMOEBA force field settings hal: cut 10 taper 8 vscale 0 0 1 1 multipole: cut 10 aewald 0 mscale 0 0 0.4 1 polar: cut 10 aewald 0 pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 1 1 1 1 d/u scale 0 1 precondition: cut 4.5 - generated 0 of 1 mixed pair_coeff terms from geometric mixing rule +Generated 0 of 1 mixed pair_coeff terms from geometric mixing rule Neighbor list info ... update every 1 steps, delay 10 steps, check yes max neighbors/atom: 2000, page size: 100000 @@ -95,43 +97,38 @@ Neighbor list info ... pair build: half/bin/newton stencil: half/bin/3d bin: standard - AMOEBA/HIPPO group count: 6 -Per MPI rank memory allocation (min/avg/max) = 49.53 | 49.53 | 49.53 Mbytes + AMOEBA group count: 6 +Per MPI rank memory allocation (min/avg/max) = 48.28 | 48.28 | 48.28 Mbytes Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] 0 0 -48.469664 1.9820353 2.2499329 0 0 4.2319683 -44.237696 -26322.671 -28303.103 -27669.614 -22995.296 1312.6688 2624.8394 4042.0489 - 10 6.3616471 -46.626437 1.7910812 0.25704063 0 0 2.0481218 -44.255947 -23813.06 -24671.886 -17167.34 -30208.043 -474.208 -8339.5934 -5278.359 - 20 15.149798 -48.177533 1.1130818 2.007499 0 0 3.1205807 -44.289255 -16468.855 -20150.975 -18596.629 -12107.083 885.52697 6320.1867 3064.949 - 30 17.896968 -45.959274 0.54802739 0.19519937 0 0 0.74322676 -44.309141 -4749.0624 -9053.7792 -182.37209 -6721.7499 -2003.7641 -627.56998 -1658.1301 - 40 16.203813 -46.840973 0.1371751 1.5793326 0 0 1.7165077 -44.303357 9267.4858 6108.7966 4116.4548 16028.336 380.03787 8468.0648 4492.3331 - 50 11.584975 -45.166711 0.017120512 0.28622888 0 0 0.30334939 -44.276308 22189.511 21453.083 22339.471 21668.607 150.93139 1059.5253 200.0668 - 60 10.002055 -45.994946 0.037889337 1.1987062 0 0 1.2365956 -44.251509 30944.004 35801.925 19832.696 36241.326 2042.3054 2320.5193 1660.0834 - 70 11.272241 -45.411622 0.07431614 0.51778317 0 0 0.59209931 -44.248316 32055.564 39306.193 30181.52 25601.501 1373.4778 -4501.0686 -2570.4767 - 80 14.011502 -46.081444 0.089688317 1.006928 0 0 1.0966163 -44.274812 25661.838 38836.598 12603.734 24205.867 -867.36437 -4211.9639 -2820.6725 - 90 17.659498 -46.247295 0.21744649 0.82687716 0 0 1.0443237 -44.308098 12101.207 19426.995 14142.311 1046.299 -2157.5418 -2141.2454 -2621.456 - 100 17.630532 -46.788272 0.61811601 0.9654966 0 0 1.5836126 -44.311254 -4455.3587 3961.5737 -11554.095 -7458.8012 -3120.9771 -1532.1706 -1499.0117 -Loop time of 0.0438592 on 1 procs for 100 steps with 18 atoms + 1 5.318656 -48.202382 1.5369859 2.1322394 0 0 3.6692253 -44.26364 -20236.446 -20385.617 -23104.961 -17727.152 417.52781 2728.2976 3750.7708 + 2 14.415671 -47.491537 0.6389772 1.8136212 0 0 2.4525984 -44.308442 -4127.4968 1051.8436 -10980.156 -3832.1256 -2285.3376 2991.8274 2945.888 + 3 15.996484 -46.59119 0.087228651 1.3862662 0 0 1.4734948 -44.307093 15705.166 28374.161 4124.662 13087.621 -6242.1769 3159.6508 1787.4159 + 4 10.888785 -45.839064 0.062461924 0.96598997 0 0 1.0284519 -44.258837 30226.38 48920.372 15666.108 25051.837 -9443.9251 2603.8275 435.5257 + 5 10.58575 -45.503287 0.071817565 0.64254674 0 0 0.71436431 -44.252503 31899.04 51066.283 18170.57 25448.409 -9478.6752 638.72265 -1011.7679 +Loop time of 0.00100021 on 1 procs for 5 steps with 18 atoms -Performance: 196.994 ns/day, 0.122 hours/ns, 2280.022 timesteps/s -95.1% CPU use with 1 MPI tasks x no OpenMP threads +Performance: 431.907 ns/day, 0.056 hours/ns, 4998.925 timesteps/s +99.8% CPU use with 1 MPI tasks x 1 OpenMP threads -AMEOBA/HIPPO timing breakdown: - Init time: 0.000324764 0.00770058 - Hal time: 0.00500441 11.8661 - Mpole time: 0.00442974 10.5035 - Induce time: 0.0210286 49.8617 - Polar time: 0.0113696 26.9588 - Total time: 0.042174 +AMOEBA timing breakdown: + Init time: 1.2295e-05 1.38% + Hal time: 6.2308e-05 6.98% + Mpole time: 0.000124591 13.97% + Induce time: 0.000432719 48.51% + Polar time: 0.000259676 29.11% + Total time: 0.000892068 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.042221 | 0.042221 | 0.042221 | 0.0 | 96.26 -Bond | 0.00021632 | 0.00021632 | 0.00021632 | 0.0 | 0.49 +Pair | 0.00089392 | 0.00089392 | 0.00089392 | 0.0 | 89.37 +Bond | 6.685e-06 | 6.685e-06 | 6.685e-06 | 0.0 | 0.67 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 1.6322e-05 | 1.6322e-05 | 1.6322e-05 | 0.0 | 0.04 -Output | 0.0012472 | 0.0012472 | 0.0012472 | 0.0 | 2.84 -Modify | 7.9638e-05 | 7.9638e-05 | 7.9638e-05 | 0.0 | 0.18 -Other | | 7.889e-05 | | | 0.18 +Comm | 6.67e-07 | 6.67e-07 | 6.67e-07 | 0.0 | 0.07 +Output | 9.0869e-05 | 9.0869e-05 | 9.0869e-05 | 0.0 | 9.08 +Modify | 2.517e-06 | 2.517e-06 | 2.517e-06 | 0.0 | 0.25 +Other | | 5.561e-06 | | | 0.56 Nlocal: 18 ave 18 max 18 min Histogram: 1 0 0 0 0 0 0 0 0 0 diff --git a/examples/amoeba/log.water_hexamer.amoeba.4 b/examples/amoeba/log.5Jul22.water_hexamer.amoeba.g++.4 similarity index 50% rename from examples/amoeba/log.water_hexamer.amoeba.4 rename to examples/amoeba/log.5Jul22.water_hexamer.amoeba.g++.4 index 3a27656e78..5d1e55ed04 100644 --- a/examples/amoeba/log.water_hexamer.amoeba.4 +++ b/examples/amoeba/log.5Jul22.water_hexamer.amoeba.g++.4 @@ -1,4 +1,6 @@ -LAMMPS (24 Mar 2022) +LAMMPS (23 Jun 2022) +OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (src/comm.cpp:98) + using 1 OpenMP thread(s) per MPI task # water hexamer with AMOEBA or HIPPO units real @@ -39,7 +41,7 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of special neighbors special bonds CPU = 0.000 seconds - read_data CPU = 0.008 seconds + read_data CPU = 0.004 seconds # force field @@ -63,8 +65,8 @@ compute virial all pressure NULL virial thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] -dump 1 all custom 10 dump.water_hexamer id type x y z fx fy fz -dump_modify 1 sort id +#dump 1 all custom 10 dump.water_hexamer id type x y z fx fy fz +#dump_modify 1 sort id # zero step run @@ -74,15 +76,15 @@ dump_modify 1 sort id fix 1 all nve -thermo 10 -run 100 -AMOEBA/HIPPO force field settings +thermo 1 +run 5 +AMOEBA force field settings hal: cut 10 taper 8 vscale 0 0 1 1 multipole: cut 10 aewald 0 mscale 0 0 0.4 1 polar: cut 10 aewald 0 pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 1 1 1 1 d/u scale 0 1 precondition: cut 4.5 - generated 0 of 1 mixed pair_coeff terms from geometric mixing rule +Generated 0 of 1 mixed pair_coeff terms from geometric mixing rule Neighbor list info ... update every 1 steps, delay 10 steps, check yes max neighbors/atom: 2000, page size: 100000 @@ -95,44 +97,39 @@ Neighbor list info ... pair build: half/bin/newton stencil: half/bin/3d bin: standard -WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (../domain.cpp:974) - AMOEBA/HIPPO group count: 6 -Per MPI rank memory allocation (min/avg/max) = 49.56 | 49.56 | 49.56 Mbytes +WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (src/domain.cpp:970) + AMOEBA group count: 6 +Per MPI rank memory allocation (min/avg/max) = 48.3 | 48.3 | 48.3 Mbytes Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] 0 0 -48.469664 1.9820353 2.2499329 0 0 4.2319683 -44.237696 -26322.671 -28303.103 -27669.614 -22995.296 1312.6688 2624.8394 4042.0489 - 10 6.3616471 -46.626437 1.7910812 0.25704063 0 0 2.0481218 -44.255947 -23813.06 -24671.886 -17167.34 -30208.043 -474.208 -8339.5934 -5278.359 - 20 15.149798 -48.177533 1.1130818 2.007499 0 0 3.1205807 -44.289255 -16468.855 -20150.975 -18596.629 -12107.083 885.52697 6320.1867 3064.949 - 30 17.896968 -45.959274 0.54802739 0.19519937 0 0 0.74322676 -44.309141 -4749.0624 -9053.7792 -182.37209 -6721.7499 -2003.7641 -627.56998 -1658.1301 - 40 16.203813 -46.840973 0.1371751 1.5793326 0 0 1.7165077 -44.303357 9267.4858 6108.7966 4116.4548 16028.336 380.03787 8468.0648 4492.3331 - 50 11.584975 -45.166711 0.017120512 0.28622888 0 0 0.30334939 -44.276308 22189.511 21453.083 22339.471 21668.607 150.93139 1059.5253 200.0668 - 60 10.002055 -45.994946 0.037889337 1.1987062 0 0 1.2365956 -44.251509 30944.004 35801.925 19832.696 36241.326 2042.3054 2320.5193 1660.0834 - 70 11.272241 -45.411622 0.07431614 0.51778317 0 0 0.59209931 -44.248316 32055.564 39306.193 30181.52 25601.501 1373.4778 -4501.0686 -2570.4767 - 80 14.011502 -46.081444 0.089688317 1.006928 0 0 1.0966163 -44.274812 25661.838 38836.598 12603.734 24205.867 -867.36437 -4211.9639 -2820.6725 - 90 17.659498 -46.247295 0.21744649 0.82687716 0 0 1.0443237 -44.308098 12101.207 19426.995 14142.311 1046.299 -2157.5418 -2141.2454 -2621.456 - 100 17.630532 -46.788272 0.61811601 0.9654966 0 0 1.5836126 -44.311254 -4455.3587 3961.5737 -11554.095 -7458.8012 -3120.9771 -1532.1706 -1499.0117 -Loop time of 0.0405754 on 4 procs for 100 steps with 18 atoms + 1 5.318656 -48.202382 1.5369859 2.1322394 0 0 3.6692253 -44.26364 -20236.446 -20385.617 -23104.961 -17727.152 417.52781 2728.2976 3750.7708 + 2 14.415671 -47.491537 0.6389772 1.8136212 0 0 2.4525984 -44.308442 -4127.4968 1051.8436 -10980.156 -3832.1256 -2285.3376 2991.8274 2945.888 + 3 15.996484 -46.59119 0.087228651 1.3862662 0 0 1.4734948 -44.307093 15705.166 28374.161 4124.662 13087.621 -6242.1769 3159.6508 1787.4159 + 4 10.888785 -45.839064 0.062461924 0.96598997 0 0 1.0284519 -44.258837 30226.38 48920.372 15666.108 25051.837 -9443.9251 2603.8275 435.5257 + 5 10.58575 -45.503287 0.071817565 0.64254674 0 0 0.71436431 -44.252503 31899.04 51066.283 18170.57 25448.409 -9478.6752 638.72265 -1011.7679 +Loop time of 0.0015204 on 4 procs for 5 steps with 18 atoms -Performance: 212.937 ns/day, 0.113 hours/ns, 2464.547 timesteps/s -98.9% CPU use with 4 MPI tasks x no OpenMP threads +Performance: 284.136 ns/day, 0.084 hours/ns, 3288.611 timesteps/s +98.8% CPU use with 4 MPI tasks x 1 OpenMP threads -AMEOBA/HIPPO timing breakdown: - Init time: 0.000756446 0.0198927 - Hal time: 0.00120064 3.15739 - Mpole time: 0.00338295 8.89637 - Induce time: 0.0273688 71.9733 - Polar time: 0.00530425 13.9489 - Total time: 0.0380263 +AMOEBA timing breakdown: + Init time: 2.00392e-05 1.57% + Hal time: 2.58605e-05 2.02% + Mpole time: 0.000137192 10.74% + Induce time: 0.000858714 67.22% + Polar time: 0.00023507 18.40% + Total time: 0.00127742 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.03816 | 0.038221 | 0.038312 | 0.0 | 94.20 -Bond | 7.0759e-05 | 8.5222e-05 | 0.00010449 | 0.0 | 0.21 +Pair | 0.0012876 | 0.0012913 | 0.0012951 | 0.0 | 84.93 +Bond | 4.076e-06 | 6.434e-06 | 1.0051e-05 | 0.0 | 0.42 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.00065721 | 0.00081724 | 0.00093857 | 0.0 | 2.01 -Output | 0.0010275 | 0.0010663 | 0.0011758 | 0.2 | 2.63 -Modify | 3.3884e-05 | 4.422e-05 | 5.7037e-05 | 0.0 | 0.11 -Other | | 0.000341 | | | 0.84 +Comm | 1.4924e-05 | 5.9337e-05 | 8.3417e-05 | 0.0 | 3.90 +Output | 0.00012796 | 0.00014846 | 0.00018928 | 0.0 | 9.76 +Modify | 2.066e-06 | 2.5358e-06 | 3.07e-06 | 0.0 | 0.17 +Other | | 1.236e-05 | | | 0.81 Nlocal: 4.5 ave 6 max 3 min Histogram: 1 0 0 1 0 0 1 0 0 1 diff --git a/examples/amoeba/log.water_hexamer.hippo.1 b/examples/amoeba/log.5Jul22.water_hexamer.hippo.g++.1 similarity index 51% rename from examples/amoeba/log.water_hexamer.hippo.1 rename to examples/amoeba/log.5Jul22.water_hexamer.hippo.g++.1 index 15d107a11b..d2a70d817d 100644 --- a/examples/amoeba/log.water_hexamer.hippo.1 +++ b/examples/amoeba/log.5Jul22.water_hexamer.hippo.g++.1 @@ -1,4 +1,6 @@ -LAMMPS (24 Mar 2022) +LAMMPS (23 Jun 2022) +OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (src/comm.cpp:98) + using 1 OpenMP thread(s) per MPI task # water hexamer with AMOEBA or HIPPO units real @@ -39,7 +41,7 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of special neighbors special bonds CPU = 0.000 seconds - read_data CPU = 0.007 seconds + read_data CPU = 0.004 seconds # force field @@ -63,8 +65,8 @@ compute virial all pressure NULL virial thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] -dump 1 all custom 10 dump.water_hexamer id type x y z fx fy fz -dump_modify 1 sort id +#dump 1 all custom 10 dump.water_hexamer id type x y z fx fy fz +#dump_modify 1 sort id # zero step run @@ -74,9 +76,9 @@ dump_modify 1 sort id fix 1 all nve -thermo 10 -run 100 -AMOEBA/HIPPO force field settings +thermo 1 +run 5 +HIPPO force field settings repulsion: cut 10 taper 8 rscale 0 0 1 1 qxfer: cut 10 taper 8 mscale 0 0 0.4 1 dispersion: cut 10 aewald 0 dspscale 0 0 0.4 1 @@ -84,7 +86,7 @@ AMOEBA/HIPPO force field settings polar: cut 10 aewald 0 pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 0.2 1 1 1 d/u scale 0 1 precondition: cut 4.5 - generated 0 of 1 mixed pair_coeff terms from geometric mixing rule +Generated 0 of 1 mixed pair_coeff terms from geometric mixing rule Neighbor list info ... update every 1 steps, delay 10 steps, check yes max neighbors/atom: 2000, page size: 100000 @@ -97,45 +99,40 @@ Neighbor list info ... pair build: half/bin/newton stencil: half/bin/3d bin: standard - AMOEBA/HIPPO group count: 6 -Per MPI rank memory allocation (min/avg/max) = 49.1 | 49.1 | 49.1 Mbytes + HIPPO group count: 6 +Per MPI rank memory allocation (min/avg/max) = 47.84 | 47.84 | 47.84 Mbytes Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] 0 0 -47.362156 1.9820353 1.6634749 0 0 3.6455102 -43.716646 -34513.768 -42206.078 -31383.641 -29951.584 2850.1184 3579.9253 5768.3698 - 10 11.52238 -45.959856 1.53397 0.085100522 0 0 1.6190706 -43.756903 -28644.676 -34867.94 -19324.955 -32842.522 -370.63233 -6452.0859 -4002.3535 - 20 20.237283 -46.772008 0.54762833 1.3835192 0 0 1.9311476 -43.815361 -10546.356 -10116.359 -17063.425 -6393.701 -1166.7608 4243.6327 3493.9596 - 30 20.666374 -45.011106 0.086797459 0.071122604 0 0 0.15792006 -43.805943 13150.762 15882.022 10964.553 10630.278 -6754.7642 -432.29165 -3783.115 - 40 10.639014 -45.430939 0.18926921 0.96410995 0 0 1.1533792 -43.738441 33402.664 41252.58 19726.586 38211.875 -6166.03 6081.5692 1815.7739 - 50 10.992432 -44.741108 0.19575431 0.25851128 0 0 0.45426559 -43.729815 37696.923 41572.466 33299.43 37168.141 -3254.5134 2.9639226 -1017.3669 - 60 19.748633 -45.461264 0.035287281 0.63217389 0 0 0.66746117 -43.793065 26212.839 28825.788 16048.096 31876.925 3504.5461 135.3505 420.28566 - 70 26.129957 -46.022729 0.30434543 0.56770169 0 0 0.87204711 -43.826579 3919.9866 -2755.6905 11500.428 517.54333 5626.9543 -2238.5786 86.305984 - 80 17.768494 -46.309777 1.1680612 0.45551823 0 0 1.6235794 -43.785801 -18335.898 -22168.789 -14488.992 -20048.346 7343.173 -2646.2196 -2525.6625 - 90 8.3822494 -47.063502 2.0182644 0.88875358 0 0 2.9070179 -43.731724 -33693.203 -43487.996 -15178.35 -43214.494 2412.6411 1993.0113 1780.7512 - 100 8.6486333 -46.517402 1.9551958 0.38696887 0 0 2.3421647 -43.736979 -34734.97 -34372.659 -28372.146 -42286.799 226.18821 40.353457 -755.93912 -Loop time of 0.0399433 on 1 procs for 100 steps with 18 atoms + 1 7.1819351 -47.135822 1.4553325 1.5620463 0 0 3.0173788 -43.754508 -26763.923 -32046.377 -25919.73 -23012.16 1848.028 3578.5744 5396.0234 + 2 18.776762 -46.526843 0.46636815 1.2906982 0 0 1.7570664 -43.818287 -6352.6601 -4602.4631 -11460.465 -4789.8629 -1296.5558 3625.7641 4391.7607 + 3 19.013509 -45.750445 0.043880608 0.9336078 0 0 0.97748841 -43.809471 18351.549 29896.314 6275.5012 17065.39 -6055.8639 3664.6024 3015.6633 + 4 11.017518 -45.12347 0.24124811 0.58878104 0 0 0.83002915 -43.735142 35358.63 54252.632 19050.919 31719.21 -9822.7607 3160.7845 1520.1368 + 5 12.143149 -44.904245 0.22320916 0.3270434 0 0 0.55025256 -43.738653 35160.919 53395.572 20272.979 30653.482 -9511.0241 1392.4959 35.692826 +Loop time of 0.00117792 on 1 procs for 5 steps with 18 atoms -Performance: 216.307 ns/day, 0.111 hours/ns, 2503.548 timesteps/s -92.6% CPU use with 1 MPI tasks x no OpenMP threads +Performance: 366.749 ns/day, 0.065 hours/ns, 4244.778 timesteps/s +95.2% CPU use with 1 MPI tasks x 1 OpenMP threads -AMEOBA/HIPPO timing breakdown: - Init time: 0.000295019 0.00770171 - Repulse time: 0.00594736 15.5261 - Disp time: 0.00261218 6.81931 - Mpole time: 0.0069314 18.095 - Induce time: 0.013694 35.7492 - Polar time: 0.00744631 19.4392 - Qxfer time: 0.001375 3.58954 - Total time: 0.0383057 +HIPPO timing breakdown: + Init time: 1.5876e-05 1.52% + Repulse time: 0.000160405 15.32% + Disp time: 5.1301e-05 4.90% + Mpole time: 0.000219996 21.01% + Induce time: 0.000352821 33.70% + Polar time: 0.000218541 20.87% + Qxfer time: 2.7842e-05 2.66% + Total time: 0.00104695 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.038344 | 0.038344 | 0.038344 | 0.0 | 96.00 -Bond | 0.00017707 | 0.00017707 | 0.00017707 | 0.0 | 0.44 +Pair | 0.0010494 | 0.0010494 | 0.0010494 | 0.0 | 89.09 +Bond | 7.408e-06 | 7.408e-06 | 7.408e-06 | 0.0 | 0.63 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 1.5549e-05 | 1.5549e-05 | 1.5549e-05 | 0.0 | 0.04 -Output | 0.0012682 | 0.0012682 | 0.0012682 | 0.0 | 3.18 -Modify | 7.0869e-05 | 7.0869e-05 | 7.0869e-05 | 0.0 | 0.18 -Other | | 6.745e-05 | | | 0.17 +Comm | 1.032e-06 | 1.032e-06 | 1.032e-06 | 0.0 | 0.09 +Output | 0.00011139 | 0.00011139 | 0.00011139 | 0.0 | 9.46 +Modify | 2.647e-06 | 2.647e-06 | 2.647e-06 | 0.0 | 0.22 +Other | | 6.086e-06 | | | 0.52 Nlocal: 18 ave 18 max 18 min Histogram: 1 0 0 0 0 0 0 0 0 0 diff --git a/examples/amoeba/log.water_hexamer.hippo.4 b/examples/amoeba/log.5Jul22.water_hexamer.hippo.g++.4 similarity index 50% rename from examples/amoeba/log.water_hexamer.hippo.4 rename to examples/amoeba/log.5Jul22.water_hexamer.hippo.g++.4 index 4b0d913edd..b33c89a1d0 100644 --- a/examples/amoeba/log.water_hexamer.hippo.4 +++ b/examples/amoeba/log.5Jul22.water_hexamer.hippo.g++.4 @@ -1,4 +1,6 @@ -LAMMPS (24 Mar 2022) +LAMMPS (23 Jun 2022) +OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (src/comm.cpp:98) + using 1 OpenMP thread(s) per MPI task # water hexamer with AMOEBA or HIPPO units real @@ -39,7 +41,7 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of special neighbors special bonds CPU = 0.000 seconds - read_data CPU = 0.008 seconds + read_data CPU = 0.003 seconds # force field @@ -63,8 +65,8 @@ compute virial all pressure NULL virial thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] -dump 1 all custom 10 dump.water_hexamer id type x y z fx fy fz -dump_modify 1 sort id +#dump 1 all custom 10 dump.water_hexamer id type x y z fx fy fz +#dump_modify 1 sort id # zero step run @@ -74,9 +76,9 @@ dump_modify 1 sort id fix 1 all nve -thermo 10 -run 100 -AMOEBA/HIPPO force field settings +thermo 1 +run 5 +HIPPO force field settings repulsion: cut 10 taper 8 rscale 0 0 1 1 qxfer: cut 10 taper 8 mscale 0 0 0.4 1 dispersion: cut 10 aewald 0 dspscale 0 0 0.4 1 @@ -84,7 +86,7 @@ AMOEBA/HIPPO force field settings polar: cut 10 aewald 0 pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 0.2 1 1 1 d/u scale 0 1 precondition: cut 4.5 - generated 0 of 1 mixed pair_coeff terms from geometric mixing rule +Generated 0 of 1 mixed pair_coeff terms from geometric mixing rule Neighbor list info ... update every 1 steps, delay 10 steps, check yes max neighbors/atom: 2000, page size: 100000 @@ -97,46 +99,41 @@ Neighbor list info ... pair build: half/bin/newton stencil: half/bin/3d bin: standard -WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (../domain.cpp:974) - AMOEBA/HIPPO group count: 6 -Per MPI rank memory allocation (min/avg/max) = 49.13 | 49.13 | 49.13 Mbytes +WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (src/domain.cpp:970) + HIPPO group count: 6 +Per MPI rank memory allocation (min/avg/max) = 47.86 | 47.86 | 47.86 Mbytes Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] 0 0 -47.362156 1.9820353 1.6634749 0 0 3.6455102 -43.716646 -34513.768 -42206.078 -31383.641 -29951.584 2850.1184 3579.9253 5768.3698 - 10 11.52238 -45.959856 1.53397 0.085100522 0 0 1.6190706 -43.756903 -28644.676 -34867.94 -19324.955 -32842.522 -370.63233 -6452.0859 -4002.3535 - 20 20.237283 -46.772008 0.54762833 1.3835192 0 0 1.9311476 -43.815361 -10546.356 -10116.359 -17063.425 -6393.701 -1166.7608 4243.6327 3493.9596 - 30 20.666374 -45.011106 0.086797459 0.071122604 0 0 0.15792006 -43.805943 13150.762 15882.022 10964.553 10630.278 -6754.7642 -432.29165 -3783.115 - 40 10.639014 -45.430939 0.18926921 0.96410995 0 0 1.1533792 -43.738441 33402.664 41252.58 19726.586 38211.875 -6166.03 6081.5692 1815.7739 - 50 10.992432 -44.741108 0.19575431 0.25851128 0 0 0.45426559 -43.729815 37696.923 41572.466 33299.43 37168.141 -3254.5134 2.9639226 -1017.3669 - 60 19.748633 -45.461264 0.035287281 0.63217389 0 0 0.66746117 -43.793065 26212.839 28825.788 16048.096 31876.925 3504.5461 135.3505 420.28566 - 70 26.129957 -46.022729 0.30434543 0.56770169 0 0 0.87204711 -43.826579 3919.9866 -2755.6905 11500.428 517.54333 5626.9543 -2238.5786 86.305984 - 80 17.768494 -46.309777 1.1680612 0.45551823 0 0 1.6235794 -43.785801 -18335.898 -22168.789 -14488.992 -20048.346 7343.173 -2646.2196 -2525.6625 - 90 8.3822494 -47.063502 2.0182644 0.88875358 0 0 2.9070179 -43.731724 -33693.203 -43487.996 -15178.35 -43214.494 2412.6411 1993.0113 1780.7512 - 100 8.6486333 -46.517402 1.9551958 0.38696887 0 0 2.3421647 -43.736979 -34734.97 -34372.659 -28372.146 -42286.799 226.18821 40.353457 -755.93912 -Loop time of 0.033787 on 4 procs for 100 steps with 18 atoms + 1 7.1819351 -47.135822 1.4553325 1.5620463 0 0 3.0173788 -43.754508 -26763.923 -32046.377 -25919.73 -23012.16 1848.028 3578.5744 5396.0234 + 2 18.776762 -46.526843 0.46636815 1.2906982 0 0 1.7570664 -43.818287 -6352.6601 -4602.4631 -11460.465 -4789.8629 -1296.5558 3625.7641 4391.7607 + 3 19.013509 -45.750445 0.043880608 0.9336078 0 0 0.97748841 -43.809471 18351.549 29896.314 6275.5012 17065.39 -6055.8639 3664.6024 3015.6633 + 4 11.017518 -45.12347 0.24124811 0.58878104 0 0 0.83002915 -43.735142 35358.63 54252.632 19050.919 31719.21 -9822.7607 3160.7845 1520.1368 + 5 12.143149 -44.904245 0.22320916 0.3270434 0 0 0.55025256 -43.738653 35160.919 53395.572 20272.979 30653.482 -9511.0241 1392.4959 35.692826 +Loop time of 0.000850973 on 4 procs for 5 steps with 18 atoms -Performance: 255.719 ns/day, 0.094 hours/ns, 2959.715 timesteps/s -99.9% CPU use with 4 MPI tasks x no OpenMP threads +Performance: 507.654 ns/day, 0.047 hours/ns, 5875.629 timesteps/s +99.4% CPU use with 4 MPI tasks x 1 OpenMP threads -AMEOBA/HIPPO timing breakdown: - Init time: 0.000724905 0.0236438 - Repulse time: 0.00306516 9.99746 - Disp time: 0.000637502 2.07931 - Mpole time: 0.00397577 12.9676 - Induce time: 0.0181268 59.123 - Polar time: 0.00377543 12.3141 - Qxfer time: 0.000349256 1.13915 - Total time: 0.0306594 +HIPPO timing breakdown: + Init time: 1.6627e-05 2.46% + Repulse time: 9.88147e-05 14.60% + Disp time: 1.35375e-05 2.00% + Mpole time: 0.000103418 15.28% + Induce time: 0.000343719 50.80% + Polar time: 9.3749e-05 13.85% + Qxfer time: 6.64925e-06 0.98% + Total time: 0.000676665 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.030576 | 0.030875 | 0.031306 | 0.2 | 91.38 -Bond | 6.4191e-05 | 7.956e-05 | 0.0001014 | 0.0 | 0.24 +Pair | 0.00068159 | 0.00068738 | 0.00069496 | 0.0 | 80.78 +Bond | 3.506e-06 | 3.8025e-06 | 4.338e-06 | 0.0 | 0.45 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.00072972 | 0.0012341 | 0.0015501 | 1.0 | 3.65 -Output | 0.0011293 | 0.0011806 | 0.0012922 | 0.2 | 3.49 -Modify | 4.0541e-05 | 4.5677e-05 | 5.4304e-05 | 0.0 | 0.14 -Other | | 0.0003717 | | | 1.10 +Comm | 1.1451e-05 | 4.4141e-05 | 5.7694e-05 | 0.0 | 5.19 +Output | 9.6072e-05 | 0.00010517 | 0.00013106 | 0.0 | 12.36 +Modify | 1.799e-06 | 1.9772e-06 | 2.149e-06 | 0.0 | 0.23 +Other | | 8.507e-06 | | | 1.00 Nlocal: 4.5 ave 6 max 3 min Histogram: 1 0 0 1 0 0 1 0 0 1 From 89e09895227e12e3c254d6803f7e9dfc4646a585 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 5 Jul 2022 07:11:09 -0400 Subject: [PATCH 531/585] add UNITS: and DATA: metadata tags to force field files --- examples/amoeba/amoeba_ubiquitin.prm | 1 + examples/amoeba/amoeba_water.prm | 1 + examples/amoeba/hippo_water.prm | 1 + examples/amoeba/log.5Jul22.ubiquitin.g++.1 | 33 +++++++++-------- examples/amoeba/log.5Jul22.ubiquitin.g++.4 | 33 +++++++++-------- .../amoeba/log.5Jul22.water_box.amoeba.g++.1 | 37 ++++++++++--------- .../amoeba/log.5Jul22.water_box.amoeba.g++.4 | 33 +++++++++-------- .../amoeba/log.5Jul22.water_box.hippo.g++.1 | 35 +++++++++--------- .../amoeba/log.5Jul22.water_box.hippo.g++.4 | 35 +++++++++--------- .../log.5Jul22.water_dimer.amoeba.g++.1 | 31 ++++++++-------- .../log.5Jul22.water_dimer.amoeba.g++.4 | 31 ++++++++-------- .../amoeba/log.5Jul22.water_dimer.hippo.g++.1 | 33 +++++++++-------- .../amoeba/log.5Jul22.water_dimer.hippo.g++.4 | 35 +++++++++--------- .../log.5Jul22.water_hexamer.amoeba.g++.1 | 29 ++++++++------- .../log.5Jul22.water_hexamer.amoeba.g++.4 | 31 ++++++++-------- .../log.5Jul22.water_hexamer.hippo.g++.1 | 37 ++++++++++--------- .../log.5Jul22.water_hexamer.hippo.g++.4 | 37 ++++++++++--------- 17 files changed, 245 insertions(+), 228 deletions(-) diff --git a/examples/amoeba/amoeba_ubiquitin.prm b/examples/amoeba/amoeba_ubiquitin.prm index 1ada1036ef..79cd9e37df 100644 --- a/examples/amoeba/amoeba_ubiquitin.prm +++ b/examples/amoeba/amoeba_ubiquitin.prm @@ -1,3 +1,4 @@ +!! DATE: 2022-07-05 UNITS: real ############################## ## ## diff --git a/examples/amoeba/amoeba_water.prm b/examples/amoeba/amoeba_water.prm index 7e46d4dbb9..5cb5a757d8 100644 --- a/examples/amoeba/amoeba_water.prm +++ b/examples/amoeba/amoeba_water.prm @@ -1,3 +1,4 @@ +!! DATE: 2022-07-05 UNITS: real ############################## ## ## diff --git a/examples/amoeba/hippo_water.prm b/examples/amoeba/hippo_water.prm index 4962dc1758..8cd658b4f3 100644 --- a/examples/amoeba/hippo_water.prm +++ b/examples/amoeba/hippo_water.prm @@ -1,3 +1,4 @@ +!! DATE: 2022-07-05 UNITS: real ############################## ## ## diff --git a/examples/amoeba/log.5Jul22.ubiquitin.g++.1 b/examples/amoeba/log.5Jul22.ubiquitin.g++.1 index fa4a577590..74019ccdf9 100644 --- a/examples/amoeba/log.5Jul22.ubiquitin.g++.1 +++ b/examples/amoeba/log.5Jul22.ubiquitin.g++.1 @@ -57,10 +57,11 @@ Finding 1-2 1-3 1-4 neighbors ... 19 = max # of 1-4 neighbors 21 = max # of special neighbors special bonds CPU = 0.003 seconds - read_data CPU = 0.042 seconds + read_data CPU = 0.077 seconds pair_style amoeba pair_coeff * * amoeba_ubiquitin.prm amoeba_ubiquitin.key +Reading potential file amoeba_ubiquitin.prm with DATE: 2022-07-05 Skipping section: AMOEBA Protein Force Field Atom Classes Skipping section: Torsion-Torsion Parameters Skipping section: Biopolymer Atom Type Conversions @@ -74,7 +75,7 @@ Finding 1-2 1-3 1-4 neighbors ... 19 = max # of 1-4 neighbors 58 = max # of 1-5 neighbors 21 = max # of special neighbors - special bonds CPU = 0.004 seconds + special bonds CPU = 0.005 seconds # thermo output @@ -123,29 +124,29 @@ Per MPI rank memory allocation (min/avg/max) = 258.3 | 258.3 | 258.3 Mbytes 3 88.8921 -35402.11 938.99299 1162.2914 220.5271 58.832521 2380.644 -30453.516 -1929.5417 -3331.1291 -2769.7218 -3350.5733 117.32302 279.72705 31.237776 4 68.740402 -35477.589 2048.0659 858.03795 218.14277 54.460022 3178.7066 -30316.325 2041.1138 594.25938 1665.7799 1030.8539 66.230421 304.28296 -155.80224 5 76.267862 -35707.869 2206.6534 736.37385 215.75693 49.401674 3208.1859 -30299.377 2276.9276 536.21124 1893.4621 1258.492 92.097191 299.65604 -228.58369 -Loop time of 6.52854 on 1 procs for 5 steps with 9737 atoms +Loop time of 6.65546 on 1 procs for 5 steps with 9737 atoms -Performance: 0.066 ns/day, 362.697 hours/ns, 0.766 timesteps/s +Performance: 0.065 ns/day, 369.748 hours/ns, 0.751 timesteps/s 99.8% CPU use with 1 MPI tasks x 1 OpenMP threads AMOEBA timing breakdown: - Init time: 0.0100839 0.15% - Hal time: 1.54573 23.70% - Mpole time: 0.806911 12.37% - Induce time: 2.63878 40.46% - Polar time: 1.51971 23.30% - Total time: 6.52122 + Init time: 0.0105468 0.16% + Hal time: 1.57051 23.62% + Mpole time: 0.805631 12.12% + Induce time: 2.69099 40.48% + Polar time: 1.57015 23.62% + Total time: 6.64783 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 6.5212 | 6.5212 | 6.5212 | 0.0 | 99.89 -Bond | 0.0049597 | 0.0049597 | 0.0049597 | 0.0 | 0.08 +Pair | 6.6478 | 6.6478 | 6.6478 | 0.0 | 99.89 +Bond | 0.0052138 | 0.0052138 | 0.0052138 | 0.0 | 0.08 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.0010627 | 0.0010627 | 0.0010627 | 0.0 | 0.02 -Output | 0.00032106 | 0.00032106 | 0.00032106 | 0.0 | 0.00 -Modify | 0.00083249 | 0.00083249 | 0.00083249 | 0.0 | 0.01 -Other | | 0.0001265 | | | 0.00 +Comm | 0.0010535 | 0.0010535 | 0.0010535 | 0.0 | 0.02 +Output | 0.00033674 | 0.00033674 | 0.00033674 | 0.0 | 0.01 +Modify | 0.00085639 | 0.00085639 | 0.00085639 | 0.0 | 0.01 +Other | | 0.000145 | | | 0.00 Nlocal: 9737 ave 9737 max 9737 min Histogram: 1 0 0 0 0 0 0 0 0 0 diff --git a/examples/amoeba/log.5Jul22.ubiquitin.g++.4 b/examples/amoeba/log.5Jul22.ubiquitin.g++.4 index 057fdb5f82..fed3f9896e 100644 --- a/examples/amoeba/log.5Jul22.ubiquitin.g++.4 +++ b/examples/amoeba/log.5Jul22.ubiquitin.g++.4 @@ -57,10 +57,11 @@ Finding 1-2 1-3 1-4 neighbors ... 19 = max # of 1-4 neighbors 21 = max # of special neighbors special bonds CPU = 0.001 seconds - read_data CPU = 0.049 seconds + read_data CPU = 0.036 seconds pair_style amoeba pair_coeff * * amoeba_ubiquitin.prm amoeba_ubiquitin.key +Reading potential file amoeba_ubiquitin.prm with DATE: 2022-07-05 Skipping section: AMOEBA Protein Force Field Atom Classes Skipping section: Torsion-Torsion Parameters Skipping section: Biopolymer Atom Type Conversions @@ -123,29 +124,29 @@ Per MPI rank memory allocation (min/avg/max) = 144.2 | 144.7 | 145.4 Mbytes 3 88.8921 -35402.11 938.99299 1162.2914 220.5271 58.832521 2380.644 -30453.516 -1929.5417 -3331.1291 -2769.7218 -3350.5733 117.32302 279.72705 31.237776 4 68.740402 -35477.589 2048.0659 858.03795 218.14277 54.460022 3178.7066 -30316.325 2041.1138 594.25938 1665.7799 1030.8539 66.230421 304.28296 -155.80224 5 76.267862 -35707.869 2206.6534 736.37385 215.75693 49.401674 3208.1859 -30299.377 2276.9276 536.21124 1893.4621 1258.492 92.097191 299.65604 -228.58369 -Loop time of 2.20325 on 4 procs for 5 steps with 9737 atoms +Loop time of 2.1516 on 4 procs for 5 steps with 9737 atoms -Performance: 0.196 ns/day, 122.403 hours/ns, 2.269 timesteps/s -99.1% CPU use with 4 MPI tasks x 1 OpenMP threads +Performance: 0.201 ns/day, 119.533 hours/ns, 2.324 timesteps/s +99.4% CPU use with 4 MPI tasks x 1 OpenMP threads AMOEBA timing breakdown: - Init time: 0.0117181 0.53% - Hal time: 0.442973 20.14% - Mpole time: 0.287778 13.09% - Induce time: 0.94261 42.86% - Polar time: 0.514081 23.38% - Total time: 2.19916 + Init time: 0.0116891 0.54% + Hal time: 0.423411 19.72% + Mpole time: 0.269917 12.57% + Induce time: 0.929983 43.30% + Polar time: 0.512586 23.87% + Total time: 2.14759 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 2.1991 | 2.1992 | 2.1996 | 0.0 | 99.82 -Bond | 0.0011873 | 0.0014547 | 0.0016743 | 0.5 | 0.07 +Pair | 2.1477 | 2.1477 | 2.1477 | 0.0 | 99.82 +Bond | 0.001184 | 0.0014529 | 0.0016771 | 0.5 | 0.07 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.0014371 | 0.0018264 | 0.0020772 | 0.6 | 0.08 -Output | 0.0002413 | 0.00029218 | 0.00037812 | 0.0 | 0.01 -Modify | 0.0002694 | 0.00029873 | 0.00032365 | 0.0 | 0.01 -Other | | 0.000135 | | | 0.01 +Comm | 0.0015356 | 0.0017027 | 0.001922 | 0.4 | 0.08 +Output | 0.00027025 | 0.0003219 | 0.00040484 | 0.0 | 0.01 +Modify | 0.00028633 | 0.00030716 | 0.00032386 | 0.0 | 0.01 +Other | | 0.0001328 | | | 0.01 Nlocal: 2434.25 ave 2498 max 2390 min Histogram: 1 1 0 0 1 0 0 0 0 1 diff --git a/examples/amoeba/log.5Jul22.water_box.amoeba.g++.1 b/examples/amoeba/log.5Jul22.water_box.amoeba.g++.1 index 3837b067f7..23b9fee06f 100644 --- a/examples/amoeba/log.5Jul22.water_box.amoeba.g++.1 +++ b/examples/amoeba/log.5Jul22.water_box.amoeba.g++.1 @@ -40,13 +40,14 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-3 neighbors 1 = max # of 1-4 neighbors 2 = max # of special neighbors - special bonds CPU = 0.000 seconds - read_data CPU = 0.004 seconds + special bonds CPU = 0.001 seconds + read_data CPU = 0.012 seconds # force field pair_style amoeba pair_coeff * * amoeba_water.prm amoeba_water_box.key +Reading potential file amoeba_water.prm with DATE: 2022-07-05 special_bonds lj/coul 0.5 0.5 0.5 one/five yes Finding 1-2 1-3 1-4 neighbors ... @@ -57,7 +58,7 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of 1-5 neighbors 2 = max # of special neighbors - special bonds CPU = 0.000 seconds + special bonds CPU = 0.001 seconds # thermo output @@ -111,29 +112,29 @@ Per MPI rank memory allocation (min/avg/max) = 56.94 | 56.94 | 56.94 Mbytes 80 171.83506 -2388.0612 76.465932 49.1299 0 0 125.59583 -1931.067 2210.3658 -318.23867 330.74353 -395.26693 -43.142216 252.53012 -1987.0412 90 175.73401 -2423.8154 90.786573 63.719496 0 0 154.50607 -1930.3915 -916.91571 -3942.3954 -2566.5361 -3414.8202 199.82369 2365.9443 -266.38604 100 173.72684 -2422.367 99.75941 57.294464 0 0 157.05387 -1930.2663 -3585.8356 -5734.1341 -5882.0146 -6232.4353 -227.79935 959.68225 404.47924 -Loop time of 9.20176 on 1 procs for 100 steps with 648 atoms +Loop time of 9.23157 on 1 procs for 100 steps with 648 atoms -Performance: 0.939 ns/day, 25.560 hours/ns, 10.867 timesteps/s +Performance: 0.936 ns/day, 25.643 hours/ns, 10.832 timesteps/s 99.8% CPU use with 1 MPI tasks x 1 OpenMP threads AMOEBA timing breakdown: - Init time: 0.0197604 0.22% - Hal time: 0.384028 4.18% - Mpole time: 0.939829 10.23% - Induce time: 6.03232 65.64% - Polar time: 1.81401 19.74% - Total time: 9.18998 + Init time: 0.0194993 0.21% + Hal time: 0.383028 4.15% + Mpole time: 0.935775 10.15% + Induce time: 6.06306 65.76% + Polar time: 1.81839 19.72% + Total time: 9.21978 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 9.1903 | 9.1903 | 9.1903 | 0.0 | 99.88 -Bond | 0.0024644 | 0.0024644 | 0.0024644 | 0.0 | 0.03 -Neigh | 0.0045623 | 0.0045623 | 0.0045623 | 0.0 | 0.05 -Comm | 0.0024492 | 0.0024492 | 0.0024492 | 0.0 | 0.03 -Output | 0.00046866 | 0.00046866 | 0.00046866 | 0.0 | 0.01 -Modify | 0.00071308 | 0.00071308 | 0.00071308 | 0.0 | 0.01 -Other | | 0.000819 | | | 0.01 +Pair | 9.2201 | 9.2201 | 9.2201 | 0.0 | 99.88 +Bond | 0.0024949 | 0.0024949 | 0.0024949 | 0.0 | 0.03 +Neigh | 0.0046051 | 0.0046051 | 0.0046051 | 0.0 | 0.05 +Comm | 0.0023611 | 0.0023611 | 0.0023611 | 0.0 | 0.03 +Output | 0.00045516 | 0.00045516 | 0.00045516 | 0.0 | 0.00 +Modify | 0.00070554 | 0.00070554 | 0.00070554 | 0.0 | 0.01 +Other | | 0.0008327 | | | 0.01 Nlocal: 648 ave 648 max 648 min Histogram: 1 0 0 0 0 0 0 0 0 0 diff --git a/examples/amoeba/log.5Jul22.water_box.amoeba.g++.4 b/examples/amoeba/log.5Jul22.water_box.amoeba.g++.4 index a42f463747..1db1f9abee 100644 --- a/examples/amoeba/log.5Jul22.water_box.amoeba.g++.4 +++ b/examples/amoeba/log.5Jul22.water_box.amoeba.g++.4 @@ -41,12 +41,13 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of special neighbors special bonds CPU = 0.000 seconds - read_data CPU = 0.004 seconds + read_data CPU = 0.005 seconds # force field pair_style amoeba pair_coeff * * amoeba_water.prm amoeba_water_box.key +Reading potential file amoeba_water.prm with DATE: 2022-07-05 special_bonds lj/coul 0.5 0.5 0.5 one/five yes Finding 1-2 1-3 1-4 neighbors ... @@ -111,29 +112,29 @@ Per MPI rank memory allocation (min/avg/max) = 56.38 | 56.38 | 56.38 Mbytes 80 171.83506 -2388.0612 76.465932 49.1299 0 0 125.59583 -1931.067 2210.3658 -318.23867 330.74353 -395.26693 -43.142216 252.53012 -1987.0412 90 175.73401 -2423.8154 90.786573 63.719496 0 0 154.50607 -1930.3915 -916.91571 -3942.3954 -2566.5361 -3414.8202 199.82369 2365.9443 -266.38604 100 173.72684 -2422.367 99.75941 57.294464 0 0 157.05387 -1930.2663 -3585.8356 -5734.1341 -5882.0146 -6232.4353 -227.79935 959.68225 404.47924 -Loop time of 3.56288 on 4 procs for 100 steps with 648 atoms +Loop time of 3.62992 on 4 procs for 100 steps with 648 atoms -Performance: 2.425 ns/day, 9.897 hours/ns, 28.067 timesteps/s +Performance: 2.380 ns/day, 10.083 hours/ns, 27.549 timesteps/s 99.3% CPU use with 4 MPI tasks x 1 OpenMP threads AMOEBA timing breakdown: - Init time: 0.0211994 0.60% - Hal time: 0.112106 3.15% - Mpole time: 0.321265 9.04% - Induce time: 2.48321 69.88% - Polar time: 0.61587 17.33% - Total time: 3.55367 + Init time: 0.0211291 0.58% + Hal time: 0.114718 3.17% + Mpole time: 0.329891 9.11% + Induce time: 2.5339 69.99% + Polar time: 0.620639 17.14% + Total time: 3.6203 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 3.5543 | 3.5544 | 3.5544 | 0.0 | 99.76 -Bond | 0.00084867 | 0.0008661 | 0.00088053 | 0.0 | 0.02 -Neigh | 0.0014115 | 0.0014132 | 0.0014157 | 0.0 | 0.04 -Comm | 0.0044654 | 0.0045745 | 0.004671 | 0.1 | 0.13 -Output | 0.00037263 | 0.00042347 | 0.00054242 | 0.0 | 0.01 -Modify | 0.00035262 | 0.00036625 | 0.00037678 | 0.0 | 0.01 -Other | | 0.0008691 | | | 0.02 +Pair | 3.6209 | 3.621 | 3.6211 | 0.0 | 99.75 +Bond | 0.00085544 | 0.00087038 | 0.00090469 | 0.0 | 0.02 +Neigh | 0.0014354 | 0.0014405 | 0.0014453 | 0.0 | 0.04 +Comm | 0.004823 | 0.0048746 | 0.0049092 | 0.0 | 0.13 +Output | 0.00038727 | 0.00043628 | 0.00055233 | 0.0 | 0.01 +Modify | 0.00033814 | 0.0003491 | 0.00037267 | 0.0 | 0.01 +Other | | 0.0009691 | | | 0.03 Nlocal: 162 ave 164 max 159 min Histogram: 1 0 0 0 0 0 1 0 1 1 diff --git a/examples/amoeba/log.5Jul22.water_box.hippo.g++.1 b/examples/amoeba/log.5Jul22.water_box.hippo.g++.1 index 60b16d39c1..1c998687f4 100644 --- a/examples/amoeba/log.5Jul22.water_box.hippo.g++.1 +++ b/examples/amoeba/log.5Jul22.water_box.hippo.g++.1 @@ -47,6 +47,7 @@ Finding 1-2 1-3 1-4 neighbors ... pair_style hippo pair_coeff * * hippo_water.prm hippo_water_box.key +Reading potential file hippo_water.prm with DATE: 2022-07-05 special_bonds lj/coul 0.5 0.5 0.5 one/five yes Finding 1-2 1-3 1-4 neighbors ... @@ -108,31 +109,31 @@ Per MPI rank memory allocation (min/avg/max) = 56.46 | 56.46 | 56.46 Mbytes 3 83.751912 -2189.1561 36.936027 32.349803 0 0 69.285831 -1958.3477 1505.3642 2789.4989 -1919.6532 227.71216 3.4467207 240.18575 -91.250567 4 59.186129 -2195.3882 116.40559 17.314099 0 0 133.71969 -1947.5231 7666.6109 9441.7634 4355.1915 6787.0543 329.33631 -768.83277 -966.66638 5 70.911532 -2215.1422 115.71443 14.75745 0 0 130.47188 -1947.9114 7292.9034 8506.6309 4019.0295 6458.6256 348.80878 -911.32703 -1060.6123 -Loop time of 0.328811 on 1 procs for 5 steps with 648 atoms +Loop time of 0.326218 on 1 procs for 5 steps with 648 atoms -Performance: 1.314 ns/day, 18.267 hours/ns, 15.206 timesteps/s -99.7% CPU use with 1 MPI tasks x 1 OpenMP threads +Performance: 1.324 ns/day, 18.123 hours/ns, 15.327 timesteps/s +99.8% CPU use with 1 MPI tasks x 1 OpenMP threads HIPPO timing breakdown: - Init time: 0.000849843 0.26% - Repulse time: 0.0386964 11.79% - Disp time: 0.0176955 5.39% - Mpole time: 0.0625716 19.06% - Induce time: 0.122108 37.20% - Polar time: 0.0762897 23.24% - Qxfer time: 0.010031 3.06% - Total time: 0.328242 + Init time: 0.000842282 0.26% + Repulse time: 0.0383544 11.78% + Disp time: 0.0173558 5.33% + Mpole time: 0.0613861 18.85% + Induce time: 0.121337 37.26% + Polar time: 0.0763061 23.43% + Qxfer time: 0.0101016 3.10% + Total time: 0.325683 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.32826 | 0.32826 | 0.32826 | 0.0 | 99.83 -Bond | 0.00014786 | 0.00014786 | 0.00014786 | 0.0 | 0.04 +Pair | 0.3257 | 0.3257 | 0.3257 | 0.0 | 99.84 +Bond | 0.00013737 | 0.00013737 | 0.00013737 | 0.0 | 0.04 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 9.3603e-05 | 9.3603e-05 | 9.3603e-05 | 0.0 | 0.03 -Output | 0.00022715 | 0.00022715 | 0.00022715 | 0.0 | 0.07 -Modify | 5.5594e-05 | 5.5594e-05 | 5.5594e-05 | 0.0 | 0.02 -Other | | 2.723e-05 | | | 0.01 +Comm | 0.0001122 | 0.0001122 | 0.0001122 | 0.0 | 0.03 +Output | 0.00020981 | 0.00020981 | 0.00020981 | 0.0 | 0.06 +Modify | 3.4058e-05 | 3.4058e-05 | 3.4058e-05 | 0.0 | 0.01 +Other | | 2.595e-05 | | | 0.01 Nlocal: 648 ave 648 max 648 min Histogram: 1 0 0 0 0 0 0 0 0 0 diff --git a/examples/amoeba/log.5Jul22.water_box.hippo.g++.4 b/examples/amoeba/log.5Jul22.water_box.hippo.g++.4 index a17781a2b5..80730c0301 100644 --- a/examples/amoeba/log.5Jul22.water_box.hippo.g++.4 +++ b/examples/amoeba/log.5Jul22.water_box.hippo.g++.4 @@ -47,6 +47,7 @@ Finding 1-2 1-3 1-4 neighbors ... pair_style hippo pair_coeff * * hippo_water.prm hippo_water_box.key +Reading potential file hippo_water.prm with DATE: 2022-07-05 special_bonds lj/coul 0.5 0.5 0.5 one/five yes Finding 1-2 1-3 1-4 neighbors ... @@ -108,31 +109,31 @@ Per MPI rank memory allocation (min/avg/max) = 55.94 | 55.94 | 55.94 Mbytes 3 83.751912 -2189.1561 36.936027 32.349803 0 0 69.285831 -1958.3477 1505.3642 2789.4989 -1919.6532 227.71216 3.4467207 240.18575 -91.250567 4 59.186129 -2195.3882 116.40559 17.314099 0 0 133.71969 -1947.5231 7666.6109 9441.7634 4355.1915 6787.0543 329.33631 -768.83277 -966.66638 5 70.911532 -2215.1422 115.71443 14.75745 0 0 130.47188 -1947.9114 7292.9034 8506.6309 4019.0295 6458.6256 348.80878 -911.32703 -1060.6123 -Loop time of 0.122174 on 4 procs for 5 steps with 648 atoms +Loop time of 0.122 on 4 procs for 5 steps with 648 atoms -Performance: 3.536 ns/day, 6.787 hours/ns, 40.925 timesteps/s -98.8% CPU use with 4 MPI tasks x 1 OpenMP threads +Performance: 3.541 ns/day, 6.778 hours/ns, 40.984 timesteps/s +98.6% CPU use with 4 MPI tasks x 1 OpenMP threads HIPPO timing breakdown: - Init time: 0.00112002 0.93% - Repulse time: 0.0120679 9.97% - Disp time: 0.00648732 5.36% - Mpole time: 0.0211822 17.50% - Induce time: 0.0497719 41.12% - Polar time: 0.0274737 22.70% - Qxfer time: 0.00294446 2.43% - Total time: 0.121048 + Init time: 0.000810221 0.67% + Repulse time: 0.0125366 10.36% + Disp time: 0.00623213 5.15% + Mpole time: 0.0210595 17.40% + Induce time: 0.0506279 41.83% + Polar time: 0.026832 22.17% + Qxfer time: 0.00292863 2.42% + Total time: 0.121027 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.12105 | 0.12112 | 0.12123 | 0.0 | 99.14 -Bond | 5.27e-05 | 5.9124e-05 | 6.5605e-05 | 0.0 | 0.05 +Pair | 0.12089 | 0.12109 | 0.12131 | 0.0 | 99.25 +Bond | 4.8642e-05 | 5.2114e-05 | 6.0555e-05 | 0.0 | 0.04 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.00038065 | 0.0005645 | 0.00066198 | 0.0 | 0.46 -Output | 0.00030705 | 0.00035011 | 0.00042646 | 0.0 | 0.29 -Modify | 2.8994e-05 | 3.163e-05 | 3.6394e-05 | 0.0 | 0.03 -Other | | 4.464e-05 | | | 0.04 +Comm | 0.00035781 | 0.00058015 | 0.00076608 | 0.0 | 0.48 +Output | 0.0001878 | 0.00022879 | 0.00026441 | 0.0 | 0.19 +Modify | 1.7668e-05 | 1.8481e-05 | 1.9751e-05 | 0.0 | 0.02 +Other | | 3.389e-05 | | | 0.03 Nlocal: 162 ave 166 max 159 min Histogram: 2 0 0 0 0 0 0 1 0 1 diff --git a/examples/amoeba/log.5Jul22.water_dimer.amoeba.g++.1 b/examples/amoeba/log.5Jul22.water_dimer.amoeba.g++.1 index f06e3e9380..c9aa2ba0a1 100644 --- a/examples/amoeba/log.5Jul22.water_dimer.amoeba.g++.1 +++ b/examples/amoeba/log.5Jul22.water_dimer.amoeba.g++.1 @@ -47,6 +47,7 @@ Finding 1-2 1-3 1-4 neighbors ... pair_style amoeba pair_coeff * * amoeba_water.prm amoeba_water.key +Reading potential file amoeba_water.prm with DATE: 2022-07-05 special_bonds lj/coul 0.5 0.5 0.5 one/five yes Finding 1-2 1-3 1-4 neighbors ... @@ -107,29 +108,29 @@ Per MPI rank memory allocation (min/avg/max) = 48.33 | 48.33 | 48.33 Mbytes 3 22.599529 -5.0641035 0.0093422156 0.28736734 0 0 0.29670956 -4.4305695 7832.024 -6436.638 34275.274 -8676.6339 -46.038158 -20245.105 -46.202354 4 30.447598 -5.0072832 0.0076827791 0.11282886 0 0 0.12051164 -4.432979 12374.854 6652.5061 24658.364 -25.4576 -23.025707 -13137.295 -27.801932 5 33.189086 -4.9523094 0.0086012541 0.015399005 0 0 0.024000259 -4.4336573 10023.674 11810.883 8754.5769 3140.658 0.25267021 -3546.6216 -6.83205 -Loop time of 0.000286908 on 1 procs for 5 steps with 6 atoms +Loop time of 0.000214688 on 1 procs for 5 steps with 6 atoms -Performance: 1505.709 ns/day, 0.016 hours/ns, 17427.189 timesteps/s -98.6% CPU use with 1 MPI tasks x 1 OpenMP threads +Performance: 2012.222 ns/day, 0.012 hours/ns, 23289.611 timesteps/s +65.7% CPU use with 1 MPI tasks x 1 OpenMP threads AMOEBA timing breakdown: - Init time: 7.417e-06 4.75% - Hal time: 8.458e-06 5.42% - Mpole time: 2.2734e-05 14.57% - Induce time: 7.4016e-05 47.43% - Polar time: 4.2972e-05 27.54% - Total time: 0.00015604 + Init time: 5.306e-06 4.54% + Hal time: 6.681e-06 5.72% + Mpole time: 1.6221e-05 13.88% + Induce time: 5.6723e-05 48.54% + Polar time: 3.1532e-05 26.98% + Total time: 0.000116854 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.00015922 | 0.00015922 | 0.00015922 | 0.0 | 55.49 -Bond | 5.034e-06 | 5.034e-06 | 5.034e-06 | 0.0 | 1.75 +Pair | 0.00011888 | 0.00011888 | 0.00011888 | 0.0 | 55.37 +Bond | 3.797e-06 | 3.797e-06 | 3.797e-06 | 0.0 | 1.77 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 8.49e-07 | 8.49e-07 | 8.49e-07 | 0.0 | 0.30 -Output | 0.00011336 | 0.00011336 | 0.00011336 | 0.0 | 39.51 -Modify | 2.093e-06 | 2.093e-06 | 2.093e-06 | 0.0 | 0.73 -Other | | 6.355e-06 | | | 2.21 +Comm | 7.24e-07 | 7.24e-07 | 7.24e-07 | 0.0 | 0.34 +Output | 8.4738e-05 | 8.4738e-05 | 8.4738e-05 | 0.0 | 39.47 +Modify | 1.53e-06 | 1.53e-06 | 1.53e-06 | 0.0 | 0.71 +Other | | 5.022e-06 | | | 2.34 Nlocal: 6 ave 6 max 6 min Histogram: 1 0 0 0 0 0 0 0 0 0 diff --git a/examples/amoeba/log.5Jul22.water_dimer.amoeba.g++.4 b/examples/amoeba/log.5Jul22.water_dimer.amoeba.g++.4 index 285d3512bf..94901fdf24 100644 --- a/examples/amoeba/log.5Jul22.water_dimer.amoeba.g++.4 +++ b/examples/amoeba/log.5Jul22.water_dimer.amoeba.g++.4 @@ -47,6 +47,7 @@ Finding 1-2 1-3 1-4 neighbors ... pair_style amoeba pair_coeff * * amoeba_water.prm amoeba_water.key +Reading potential file amoeba_water.prm with DATE: 2022-07-05 special_bonds lj/coul 0.5 0.5 0.5 one/five yes Finding 1-2 1-3 1-4 neighbors ... @@ -107,29 +108,29 @@ Per MPI rank memory allocation (min/avg/max) = 48.35 | 48.48 | 48.62 Mbytes 3 22.599529 -5.0641035 0.0093422156 0.28736734 0 0 0.29670956 -4.4305695 7832.024 -6436.638 34275.274 -8676.6339 -46.038158 -20245.105 -46.202354 4 30.447598 -5.0072832 0.0076827791 0.11282886 0 0 0.12051164 -4.432979 12374.854 6652.5061 24658.364 -25.4576 -23.025707 -13137.295 -27.801932 5 33.189086 -4.9523094 0.0086012541 0.015399005 0 0 0.024000259 -4.4336573 10023.674 11810.883 8754.5769 3140.658 0.25267021 -3546.6216 -6.83205 -Loop time of 0.000582267 on 4 procs for 5 steps with 6 atoms +Loop time of 0.000598353 on 4 procs for 5 steps with 6 atoms -Performance: 741.928 ns/day, 0.032 hours/ns, 8587.130 timesteps/s -99.5% CPU use with 4 MPI tasks x 1 OpenMP threads +Performance: 721.982 ns/day, 0.033 hours/ns, 8356.278 timesteps/s +98.9% CPU use with 4 MPI tasks x 1 OpenMP threads AMOEBA timing breakdown: - Init time: 1.3264e-05 3.71% - Hal time: 3.16275e-06 0.88% - Mpole time: 2.35955e-05 6.60% - Induce time: 0.000290896 81.33% - Polar time: 2.62723e-05 7.34% - Total time: 0.000357696 + Init time: 1.3678e-05 3.81% + Hal time: 3.5045e-06 0.97% + Mpole time: 2.3748e-05 6.61% + Induce time: 0.000284514 79.15% + Polar time: 3.3521e-05 9.33% + Total time: 0.000359445 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.00036015 | 0.00038587 | 0.00040555 | 0.0 | 66.27 -Bond | 1.441e-06 | 3.3365e-06 | 5.265e-06 | 0.0 | 0.57 +Pair | 0.00035282 | 0.00038565 | 0.00040584 | 0.0 | 64.45 +Bond | 1.637e-06 | 3.2485e-06 | 4.816e-06 | 0.0 | 0.54 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 2.1512e-05 | 3.3761e-05 | 4.9368e-05 | 0.0 | 5.80 -Output | 0.00012269 | 0.00014666 | 0.00017989 | 0.0 | 25.19 -Modify | 1.659e-06 | 2.0448e-06 | 2.275e-06 | 0.0 | 0.35 -Other | | 1.059e-05 | | | 1.82 +Comm | 1.4157e-05 | 3.2696e-05 | 5.1431e-05 | 0.0 | 5.46 +Output | 0.00014589 | 0.0001627 | 0.00018978 | 0.0 | 27.19 +Modify | 1.649e-06 | 2.0097e-06 | 2.209e-06 | 0.0 | 0.34 +Other | | 1.205e-05 | | | 2.01 Nlocal: 1.5 ave 3 max 0 min Histogram: 2 0 0 0 0 0 0 0 0 2 diff --git a/examples/amoeba/log.5Jul22.water_dimer.hippo.g++.1 b/examples/amoeba/log.5Jul22.water_dimer.hippo.g++.1 index 1248c00290..dccb8dee21 100644 --- a/examples/amoeba/log.5Jul22.water_dimer.hippo.g++.1 +++ b/examples/amoeba/log.5Jul22.water_dimer.hippo.g++.1 @@ -47,6 +47,7 @@ Finding 1-2 1-3 1-4 neighbors ... pair_style hippo pair_coeff * * hippo_water.prm hippo_water.key +Reading potential file hippo_water.prm with DATE: 2022-07-05 special_bonds lj/coul 0.5 0.5 0.5 one/five yes Finding 1-2 1-3 1-4 neighbors ... @@ -109,31 +110,31 @@ Per MPI rank memory allocation (min/avg/max) = 47.9 | 47.9 | 47.9 Mbytes 3 18.15288 -4.9496234 0.010334146 0.19125791 0 0 0.20159205 -4.47748 7115.3453 -5853.149 32274.916 -8557.0355 -41.982111 -17374.865 -42.455978 4 24.248994 -4.9153331 0.0093063079 0.065238074 0 0 0.074544382 -4.4793805 11356.801 5716.9586 25838.412 -2135.3667 -22.820662 -10495.224 -28.045156 5 26.136423 -4.8829114 0.0095061937 0.0039834608 0 0 0.013489654 -4.4798832 9044.3732 10498.874 11345.536 276.34491 -1.1467483 -1185.8556 -8.820154 -Loop time of 0.000211279 on 1 procs for 5 steps with 6 atoms +Loop time of 0.000210439 on 1 procs for 5 steps with 6 atoms -Performance: 2044.690 ns/day, 0.012 hours/ns, 23665.390 timesteps/s +Performance: 2052.851 ns/day, 0.012 hours/ns, 23759.854 timesteps/s 98.4% CPU use with 1 MPI tasks x 1 OpenMP threads HIPPO timing breakdown: - Init time: 4.768e-06 4.20% - Repulse time: 1.3408e-05 11.81% - Disp time: 9.476e-06 8.35% - Mpole time: 2.1547e-05 18.98% - Induce time: 3.7631e-05 33.14% - Polar time: 2.4333e-05 21.43% - Qxfer time: 2.244e-06 1.98% - Total time: 0.000113542 + Init time: 5.006e-06 4.58% + Repulse time: 1.3587e-05 12.42% + Disp time: 5.471e-06 5.00% + Mpole time: 2.1321e-05 19.49% + Induce time: 3.7665e-05 34.43% + Polar time: 2.3919e-05 21.87% + Qxfer time: 2.295e-06 2.10% + Total time: 0.000109391 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.00011535 | 0.00011535 | 0.00011535 | 0.0 | 54.60 -Bond | 3.239e-06 | 3.239e-06 | 3.239e-06 | 0.0 | 1.53 +Pair | 0.00011125 | 0.00011125 | 0.00011125 | 0.0 | 52.86 +Bond | 3.062e-06 | 3.062e-06 | 3.062e-06 | 0.0 | 1.46 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 6.41e-07 | 6.41e-07 | 6.41e-07 | 0.0 | 0.30 -Output | 8.5752e-05 | 8.5752e-05 | 8.5752e-05 | 0.0 | 40.59 -Modify | 1.55e-06 | 1.55e-06 | 1.55e-06 | 0.0 | 0.73 -Other | | 4.744e-06 | | | 2.25 +Comm | 6.3e-07 | 6.3e-07 | 6.3e-07 | 0.0 | 0.30 +Output | 8.8087e-05 | 8.8087e-05 | 8.8087e-05 | 0.0 | 41.86 +Modify | 1.664e-06 | 1.664e-06 | 1.664e-06 | 0.0 | 0.79 +Other | | 5.749e-06 | | | 2.73 Nlocal: 6 ave 6 max 6 min Histogram: 1 0 0 0 0 0 0 0 0 0 diff --git a/examples/amoeba/log.5Jul22.water_dimer.hippo.g++.4 b/examples/amoeba/log.5Jul22.water_dimer.hippo.g++.4 index f25f4bed91..3758759b7a 100644 --- a/examples/amoeba/log.5Jul22.water_dimer.hippo.g++.4 +++ b/examples/amoeba/log.5Jul22.water_dimer.hippo.g++.4 @@ -47,6 +47,7 @@ Finding 1-2 1-3 1-4 neighbors ... pair_style hippo pair_coeff * * hippo_water.prm hippo_water.key +Reading potential file hippo_water.prm with DATE: 2022-07-05 special_bonds lj/coul 0.5 0.5 0.5 one/five yes Finding 1-2 1-3 1-4 neighbors ... @@ -109,31 +110,31 @@ Per MPI rank memory allocation (min/avg/max) = 47.91 | 48.04 | 48.18 Mbytes 3 18.15288 -4.9496234 0.010334146 0.19125791 0 0 0.20159205 -4.47748 7115.3453 -5853.149 32274.916 -8557.0355 -41.982111 -17374.865 -42.455978 4 24.248994 -4.9153331 0.0093063079 0.065238074 0 0 0.074544382 -4.4793805 11356.801 5716.9586 25838.412 -2135.3667 -22.820662 -10495.224 -28.045156 5 26.136423 -4.8829114 0.0095061937 0.0039834608 0 0 0.013489654 -4.4798832 9044.3732 10498.874 11345.536 276.34491 -1.1467483 -1185.8556 -8.820154 -Loop time of 0.000515971 on 4 procs for 5 steps with 6 atoms +Loop time of 0.000488464 on 4 procs for 5 steps with 6 atoms -Performance: 837.257 ns/day, 0.029 hours/ns, 9690.472 timesteps/s -99.1% CPU use with 4 MPI tasks x 1 OpenMP threads +Performance: 884.405 ns/day, 0.027 hours/ns, 10236.169 timesteps/s +70.9% CPU use with 4 MPI tasks x 1 OpenMP threads HIPPO timing breakdown: - Init time: 1.26765e-05 4.09% - Repulse time: 1.99082e-05 6.43% - Disp time: 3.16825e-06 1.02% - Mpole time: 3.4956e-05 11.29% - Induce time: 0.000205268 66.29% - Polar time: 3.1924e-05 10.31% - Qxfer time: 1.5545e-06 0.50% - Total time: 0.000309632 + Init time: 1.2924e-05 4.50% + Repulse time: 2.01283e-05 7.01% + Disp time: 3.04475e-06 1.06% + Mpole time: 3.51807e-05 12.25% + Induce time: 0.000183034 63.71% + Polar time: 3.13832e-05 10.92% + Qxfer time: 1.44475e-06 0.50% + Total time: 0.000287298 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.0003033 | 0.00032943 | 0.00034747 | 0.0 | 63.85 -Bond | 1.237e-06 | 2.778e-06 | 4.775e-06 | 0.0 | 0.54 +Pair | 0.00028193 | 0.00030553 | 0.00032173 | 0.0 | 62.55 +Bond | 1.317e-06 | 2.7712e-06 | 4.847e-06 | 0.0 | 0.57 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 1.2356e-05 | 3.1848e-05 | 4.3553e-05 | 0.0 | 6.17 -Output | 0.00012443 | 0.0001412 | 0.00015698 | 0.0 | 27.37 -Modify | 1.428e-06 | 2.0447e-06 | 2.545e-06 | 0.0 | 0.40 -Other | | 8.678e-06 | | | 1.68 +Comm | 1.3015e-05 | 3.0698e-05 | 4.1342e-05 | 0.0 | 6.28 +Output | 0.00012315 | 0.00013964 | 0.00015356 | 0.0 | 28.59 +Modify | 1.445e-06 | 1.881e-06 | 2.366e-06 | 0.0 | 0.39 +Other | | 7.949e-06 | | | 1.63 Nlocal: 1.5 ave 3 max 0 min Histogram: 2 0 0 0 0 0 0 0 0 2 diff --git a/examples/amoeba/log.5Jul22.water_hexamer.amoeba.g++.1 b/examples/amoeba/log.5Jul22.water_hexamer.amoeba.g++.1 index 9182a054c6..03224a076e 100644 --- a/examples/amoeba/log.5Jul22.water_hexamer.amoeba.g++.1 +++ b/examples/amoeba/log.5Jul22.water_hexamer.amoeba.g++.1 @@ -47,6 +47,7 @@ Finding 1-2 1-3 1-4 neighbors ... pair_style amoeba pair_coeff * * amoeba_water.prm amoeba_water.key +Reading potential file amoeba_water.prm with DATE: 2022-07-05 special_bonds lj/coul 0.5 0.5 0.5 one/five yes Finding 1-2 1-3 1-4 neighbors ... @@ -106,29 +107,29 @@ Per MPI rank memory allocation (min/avg/max) = 48.28 | 48.28 | 48.28 Mbytes 3 15.996484 -46.59119 0.087228651 1.3862662 0 0 1.4734948 -44.307093 15705.166 28374.161 4124.662 13087.621 -6242.1769 3159.6508 1787.4159 4 10.888785 -45.839064 0.062461924 0.96598997 0 0 1.0284519 -44.258837 30226.38 48920.372 15666.108 25051.837 -9443.9251 2603.8275 435.5257 5 10.58575 -45.503287 0.071817565 0.64254674 0 0 0.71436431 -44.252503 31899.04 51066.283 18170.57 25448.409 -9478.6752 638.72265 -1011.7679 -Loop time of 0.00100021 on 1 procs for 5 steps with 18 atoms +Loop time of 0.00100127 on 1 procs for 5 steps with 18 atoms -Performance: 431.907 ns/day, 0.056 hours/ns, 4998.925 timesteps/s +Performance: 431.450 ns/day, 0.056 hours/ns, 4993.633 timesteps/s 99.8% CPU use with 1 MPI tasks x 1 OpenMP threads AMOEBA timing breakdown: - Init time: 1.2295e-05 1.38% - Hal time: 6.2308e-05 6.98% - Mpole time: 0.000124591 13.97% - Induce time: 0.000432719 48.51% - Polar time: 0.000259676 29.11% - Total time: 0.000892068 + Init time: 1.2944e-05 1.45% + Hal time: 6.4578e-05 7.21% + Mpole time: 0.000124703 13.93% + Induce time: 0.000435232 48.60% + Polar time: 0.000257613 28.77% + Total time: 0.000895454 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.00089392 | 0.00089392 | 0.00089392 | 0.0 | 89.37 -Bond | 6.685e-06 | 6.685e-06 | 6.685e-06 | 0.0 | 0.67 +Pair | 0.00089735 | 0.00089735 | 0.00089735 | 0.0 | 89.62 +Bond | 6.783e-06 | 6.783e-06 | 6.783e-06 | 0.0 | 0.68 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 6.67e-07 | 6.67e-07 | 6.67e-07 | 0.0 | 0.07 -Output | 9.0869e-05 | 9.0869e-05 | 9.0869e-05 | 0.0 | 9.08 -Modify | 2.517e-06 | 2.517e-06 | 2.517e-06 | 0.0 | 0.25 -Other | | 5.561e-06 | | | 0.56 +Comm | 6.36e-07 | 6.36e-07 | 6.36e-07 | 0.0 | 0.06 +Output | 8.9119e-05 | 8.9119e-05 | 8.9119e-05 | 0.0 | 8.90 +Modify | 2.385e-06 | 2.385e-06 | 2.385e-06 | 0.0 | 0.24 +Other | | 4.998e-06 | | | 0.50 Nlocal: 18 ave 18 max 18 min Histogram: 1 0 0 0 0 0 0 0 0 0 diff --git a/examples/amoeba/log.5Jul22.water_hexamer.amoeba.g++.4 b/examples/amoeba/log.5Jul22.water_hexamer.amoeba.g++.4 index 5d1e55ed04..1f5aff9134 100644 --- a/examples/amoeba/log.5Jul22.water_hexamer.amoeba.g++.4 +++ b/examples/amoeba/log.5Jul22.water_hexamer.amoeba.g++.4 @@ -47,6 +47,7 @@ Finding 1-2 1-3 1-4 neighbors ... pair_style amoeba pair_coeff * * amoeba_water.prm amoeba_water.key +Reading potential file amoeba_water.prm with DATE: 2022-07-05 special_bonds lj/coul 0.5 0.5 0.5 one/five yes Finding 1-2 1-3 1-4 neighbors ... @@ -107,29 +108,29 @@ Per MPI rank memory allocation (min/avg/max) = 48.3 | 48.3 | 48.3 Mbytes 3 15.996484 -46.59119 0.087228651 1.3862662 0 0 1.4734948 -44.307093 15705.166 28374.161 4124.662 13087.621 -6242.1769 3159.6508 1787.4159 4 10.888785 -45.839064 0.062461924 0.96598997 0 0 1.0284519 -44.258837 30226.38 48920.372 15666.108 25051.837 -9443.9251 2603.8275 435.5257 5 10.58575 -45.503287 0.071817565 0.64254674 0 0 0.71436431 -44.252503 31899.04 51066.283 18170.57 25448.409 -9478.6752 638.72265 -1011.7679 -Loop time of 0.0015204 on 4 procs for 5 steps with 18 atoms +Loop time of 0.00124102 on 4 procs for 5 steps with 18 atoms -Performance: 284.136 ns/day, 0.084 hours/ns, 3288.611 timesteps/s -98.8% CPU use with 4 MPI tasks x 1 OpenMP threads +Performance: 348.100 ns/day, 0.069 hours/ns, 4028.938 timesteps/s +99.4% CPU use with 4 MPI tasks x 1 OpenMP threads AMOEBA timing breakdown: - Init time: 2.00392e-05 1.57% - Hal time: 2.58605e-05 2.02% - Mpole time: 0.000137192 10.74% - Induce time: 0.000858714 67.22% - Polar time: 0.00023507 18.40% - Total time: 0.00127742 + Init time: 1.93587e-05 1.89% + Hal time: 2.20198e-05 2.15% + Mpole time: 0.0001019 9.94% + Induce time: 0.000717017 69.95% + Polar time: 0.000164237 16.02% + Total time: 0.00102505 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.0012876 | 0.0012913 | 0.0012951 | 0.0 | 84.93 -Bond | 4.076e-06 | 6.434e-06 | 1.0051e-05 | 0.0 | 0.42 +Pair | 0.0010331 | 0.0010362 | 0.0010375 | 0.0 | 83.50 +Bond | 3.723e-06 | 5.0355e-06 | 5.6e-06 | 0.0 | 0.41 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 1.4924e-05 | 5.9337e-05 | 8.3417e-05 | 0.0 | 3.90 -Output | 0.00012796 | 0.00014846 | 0.00018928 | 0.0 | 9.76 -Modify | 2.066e-06 | 2.5358e-06 | 3.07e-06 | 0.0 | 0.17 -Other | | 1.236e-05 | | | 0.81 +Comm | 1.7872e-05 | 4.1093e-05 | 6.4155e-05 | 0.0 | 3.31 +Output | 0.00012756 | 0.00014764 | 0.00016933 | 0.0 | 11.90 +Modify | 1.808e-06 | 2.4647e-06 | 2.74e-06 | 0.0 | 0.20 +Other | | 8.565e-06 | | | 0.69 Nlocal: 4.5 ave 6 max 3 min Histogram: 1 0 0 1 0 0 1 0 0 1 diff --git a/examples/amoeba/log.5Jul22.water_hexamer.hippo.g++.1 b/examples/amoeba/log.5Jul22.water_hexamer.hippo.g++.1 index d2a70d817d..e6a765c0e8 100644 --- a/examples/amoeba/log.5Jul22.water_hexamer.hippo.g++.1 +++ b/examples/amoeba/log.5Jul22.water_hexamer.hippo.g++.1 @@ -41,12 +41,13 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of special neighbors special bonds CPU = 0.000 seconds - read_data CPU = 0.004 seconds + read_data CPU = 0.003 seconds # force field pair_style hippo pair_coeff * * hippo_water.prm hippo_water.key +Reading potential file hippo_water.prm with DATE: 2022-07-05 special_bonds lj/coul 0.5 0.5 0.5 one/five yes Finding 1-2 1-3 1-4 neighbors ... @@ -108,31 +109,31 @@ Per MPI rank memory allocation (min/avg/max) = 47.84 | 47.84 | 47.84 Mbytes 3 19.013509 -45.750445 0.043880608 0.9336078 0 0 0.97748841 -43.809471 18351.549 29896.314 6275.5012 17065.39 -6055.8639 3664.6024 3015.6633 4 11.017518 -45.12347 0.24124811 0.58878104 0 0 0.83002915 -43.735142 35358.63 54252.632 19050.919 31719.21 -9822.7607 3160.7845 1520.1368 5 12.143149 -44.904245 0.22320916 0.3270434 0 0 0.55025256 -43.738653 35160.919 53395.572 20272.979 30653.482 -9511.0241 1392.4959 35.692826 -Loop time of 0.00117792 on 1 procs for 5 steps with 18 atoms +Loop time of 0.000984386 on 1 procs for 5 steps with 18 atoms -Performance: 366.749 ns/day, 0.065 hours/ns, 4244.778 timesteps/s -95.2% CPU use with 1 MPI tasks x 1 OpenMP threads +Performance: 438.852 ns/day, 0.055 hours/ns, 5079.308 timesteps/s +99.8% CPU use with 1 MPI tasks x 1 OpenMP threads HIPPO timing breakdown: - Init time: 1.5876e-05 1.52% - Repulse time: 0.000160405 15.32% - Disp time: 5.1301e-05 4.90% - Mpole time: 0.000219996 21.01% - Induce time: 0.000352821 33.70% - Polar time: 0.000218541 20.87% - Qxfer time: 2.7842e-05 2.66% - Total time: 0.00104695 + Init time: 1.2669e-05 1.45% + Repulse time: 0.000132325 15.15% + Disp time: 4.2534e-05 4.87% + Mpole time: 0.000177341 20.30% + Induce time: 0.000303723 34.77% + Polar time: 0.000179318 20.53% + Qxfer time: 2.5413e-05 2.91% + Total time: 0.000873466 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.0010494 | 0.0010494 | 0.0010494 | 0.0 | 89.09 -Bond | 7.408e-06 | 7.408e-06 | 7.408e-06 | 0.0 | 0.63 +Pair | 0.00087559 | 0.00087559 | 0.00087559 | 0.0 | 88.95 +Bond | 6.455e-06 | 6.455e-06 | 6.455e-06 | 0.0 | 0.66 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 1.032e-06 | 1.032e-06 | 1.032e-06 | 0.0 | 0.09 -Output | 0.00011139 | 0.00011139 | 0.00011139 | 0.0 | 9.46 -Modify | 2.647e-06 | 2.647e-06 | 2.647e-06 | 0.0 | 0.22 -Other | | 6.086e-06 | | | 0.52 +Comm | 7.87e-07 | 7.87e-07 | 7.87e-07 | 0.0 | 0.08 +Output | 9.3142e-05 | 9.3142e-05 | 9.3142e-05 | 0.0 | 9.46 +Modify | 2.351e-06 | 2.351e-06 | 2.351e-06 | 0.0 | 0.24 +Other | | 6.065e-06 | | | 0.62 Nlocal: 18 ave 18 max 18 min Histogram: 1 0 0 0 0 0 0 0 0 0 diff --git a/examples/amoeba/log.5Jul22.water_hexamer.hippo.g++.4 b/examples/amoeba/log.5Jul22.water_hexamer.hippo.g++.4 index b33c89a1d0..02d9b0f6f2 100644 --- a/examples/amoeba/log.5Jul22.water_hexamer.hippo.g++.4 +++ b/examples/amoeba/log.5Jul22.water_hexamer.hippo.g++.4 @@ -41,12 +41,13 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of special neighbors special bonds CPU = 0.000 seconds - read_data CPU = 0.003 seconds + read_data CPU = 0.004 seconds # force field pair_style hippo pair_coeff * * hippo_water.prm hippo_water.key +Reading potential file hippo_water.prm with DATE: 2022-07-05 special_bonds lj/coul 0.5 0.5 0.5 one/five yes Finding 1-2 1-3 1-4 neighbors ... @@ -109,31 +110,31 @@ Per MPI rank memory allocation (min/avg/max) = 47.86 | 47.86 | 47.86 Mbytes 3 19.013509 -45.750445 0.043880608 0.9336078 0 0 0.97748841 -43.809471 18351.549 29896.314 6275.5012 17065.39 -6055.8639 3664.6024 3015.6633 4 11.017518 -45.12347 0.24124811 0.58878104 0 0 0.83002915 -43.735142 35358.63 54252.632 19050.919 31719.21 -9822.7607 3160.7845 1520.1368 5 12.143149 -44.904245 0.22320916 0.3270434 0 0 0.55025256 -43.738653 35160.919 53395.572 20272.979 30653.482 -9511.0241 1392.4959 35.692826 -Loop time of 0.000850973 on 4 procs for 5 steps with 18 atoms +Loop time of 0.00126451 on 4 procs for 5 steps with 18 atoms -Performance: 507.654 ns/day, 0.047 hours/ns, 5875.629 timesteps/s -99.4% CPU use with 4 MPI tasks x 1 OpenMP threads +Performance: 341.634 ns/day, 0.070 hours/ns, 3954.096 timesteps/s +92.2% CPU use with 4 MPI tasks x 1 OpenMP threads HIPPO timing breakdown: - Init time: 1.6627e-05 2.46% - Repulse time: 9.88147e-05 14.60% - Disp time: 1.35375e-05 2.00% - Mpole time: 0.000103418 15.28% - Induce time: 0.000343719 50.80% - Polar time: 9.3749e-05 13.85% - Qxfer time: 6.64925e-06 0.98% - Total time: 0.000676665 + Init time: 1.75712e-05 1.72% + Repulse time: 0.000116156 11.39% + Disp time: 1.69788e-05 1.66% + Mpole time: 0.000178714 17.52% + Induce time: 0.000515806 50.57% + Polar time: 0.0001659 16.27% + Qxfer time: 8.64975e-06 0.85% + Total time: 0.00101993 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.00068159 | 0.00068738 | 0.00069496 | 0.0 | 80.78 -Bond | 3.506e-06 | 3.8025e-06 | 4.338e-06 | 0.0 | 0.45 +Pair | 0.0010223 | 0.0010316 | 0.001045 | 0.0 | 81.58 +Bond | 3.062e-06 | 4.3805e-06 | 5.123e-06 | 0.0 | 0.35 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 1.1451e-05 | 4.4141e-05 | 5.7694e-05 | 0.0 | 5.19 -Output | 9.6072e-05 | 0.00010517 | 0.00013106 | 0.0 | 12.36 -Modify | 1.799e-06 | 1.9772e-06 | 2.149e-06 | 0.0 | 0.23 -Other | | 8.507e-06 | | | 1.00 +Comm | 1.4853e-05 | 6.5245e-05 | 9.2753e-05 | 0.0 | 5.16 +Output | 0.0001294 | 0.00014959 | 0.00018927 | 0.0 | 11.83 +Modify | 1.595e-06 | 2.2495e-06 | 2.798e-06 | 0.0 | 0.18 +Other | | 1.145e-05 | | | 0.91 Nlocal: 4.5 ave 6 max 3 min Histogram: 1 0 0 1 0 0 1 0 0 1 From 212048d4cca7ef3c1b6f30dc8b7ae73aa6df477d Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 5 Jul 2022 08:02:34 -0400 Subject: [PATCH 532/585] modernize tinker2lmp scripts so they run with both python2.7 and python3.x --- tools/tinker/data.py | 146 ++++++++++++++++++------------------- tools/tinker/tinker2lmp.py | 113 ++++++++++++++-------------- 2 files changed, 130 insertions(+), 129 deletions(-) diff --git a/tools/tinker/data.py b/tools/tinker/data.py index 40d6582814..b75536da93 100644 --- a/tools/tinker/data.py +++ b/tools/tinker/data.py @@ -3,16 +3,17 @@ # # Copyright (2005) Sandia Corporation. Under the terms of Contract # DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains -# certain rights in this software. This software is distributed under +# certain rights in this software. This software is distributed under # the GNU General Public License. # data tool +from __future__ import print_function oneline = "Read, write, manipulate LAMMPS data files" docstr = """ d = data("data.poly") read a LAMMPS data file, can be gzipped -d = data() create an empty data file +d = data() create an empty data file d.map(1,"id",3,"x") assign names to atom columns (1-N) @@ -26,17 +27,17 @@ d.reorder("Atoms",1,3,2,4,5) reorder columns (1-N) in a data file section 1,3,2,4,5 = new order of previous columns, can delete columns this way -d.title = "My LAMMPS data file" set title of the data file +d.title = "My LAMMPS data file" set title of the data file d.headers["atoms"] = 1500 set a header value d.sections["Bonds"] = lines set a section to list of lines (with newlines) -d.delete("bonds") delete a keyword or section of data file +d.delete("bonds") delete a keyword or section of data file d.delete("Bonds") -d.replace("Atoms",5,vec) replace Nth column of section with vector -d.newxyz(dmp,1000) replace xyz in Atoms with xyz of snapshot N +d.replace("Atoms",5,vec) replace Nth column of section with vector +d.newxyz(dmp,1000) replace xyz in Atoms with xyz of snapshot N newxyz assumes id,x,y,z are defined in both data and dump files also replaces ix,iy,iz if they are defined - + index,time,flag = d.iterator(0/1) loop over single data file snapshot time,box,atoms,bonds,tris,lines = d.viz(index) return list of viz objects @@ -53,7 +54,7 @@ time,box,atoms,bonds,tris,lines = d.viz(index) return list of viz objects NULL if bonds do not exist tris = NULL lines = NULL - + d.write("data.new") write a LAMMPS data file """ @@ -65,7 +66,7 @@ d.write("data.new") write a LAMMPS data file # Variables # title = 1st line of data file -# names = dictionary with atom attributes as keys, col #s as values +# names = dictionary with atom attributes as keys, col #s as values # headers = dictionary with header name as key, value or tuple as values # sections = dictionary with section name as key, array of lines as values # nselect = 1 = # of snapshots @@ -79,13 +80,13 @@ except: PIZZA_GUNZIP = "gunzip" # Class definition -class data: +class data(object): # -------------------------------------------------------------------- def __init__(self,*list): self.nselect = 1 - + if len(list) == 0: self.title = "LAMMPS data file" self.names = {} @@ -99,7 +100,7 @@ class data: self.title = f.readline() self.names = {} - + headers = {} while 1: line = f.readline() @@ -109,16 +110,16 @@ class data: found = 0 for keyword in hkeywords: if line.find(keyword) >= 0: - found = 1 - words = line.split() - if keyword == "xlo xhi" or keyword == "ylo yhi" or \ - keyword == "zlo zhi": - headers[keyword] = (float(words[0]),float(words[1])) - elif keyword == "xy xz yz": - headers[keyword] = \ + found = 1 + words = line.split() + if keyword == "xlo xhi" or keyword == "ylo yhi" or \ + keyword == "zlo zhi": + headers[keyword] = (float(words[0]),float(words[1])) + elif keyword == "xy xz yz": + headers[keyword] = \ (float(words[0]),float(words[1]),float(words[2])) else: - headers[keyword] = int(words[0]) + headers[keyword] = int(words[0]) if not found: break @@ -128,22 +129,21 @@ class data: for pair in skeywords: keyword,length = pair[0],pair[1] if keyword == line: - found = 1 - if not headers.has_key(length): - raise StandardError, \ - "data section %s has no matching header value" % line - f.readline() + found = 1 + if length not in headers: + raise (Exception, "data section %s has no matching header value" % line) + f.readline() list = [] - for i in xrange(headers[length]): list.append(f.readline()) + for i in range(headers[length]): list.append(f.readline()) sections[keyword] = list if not found: - raise StandardError,"invalid section %s in data file" % line + raise (Exception,"invalid section %s in data file" % line) f.readline() line = f.readline() if not line: break line = line.strip() - + f.close() self.headers = headers self.sections = sections @@ -153,7 +153,7 @@ class data: def map(self,*pairs): if len(pairs) % 2 != 0: - raise StandardError, "data map() requires pairs of mappings" + raise Exception("data map() requires pairs of mappings") for i in range(0,len(pairs),2): j = i + 1 self.names[pairs[j]] = pairs[i]-1 @@ -168,7 +168,7 @@ class data: lines = self.sections[field] for line in lines: words = line.split() - values = map(float,words) + values = list(map(float,words)) array.append(values) return array elif len(list) == 2: @@ -181,7 +181,7 @@ class data: vec.append(float(words[n])) return vec else: - raise StandardError, "invalid arguments for data.get()" + raise Exception("invalid arguments for data.get()") # -------------------------------------------------------------------- # reorder columns in a data file field @@ -192,10 +192,10 @@ class data: oldlines = self.sections[name] newlines = natoms*[""] for index in order: - for i in xrange(len(newlines)): + for i in range(len(newlines)): words = oldlines[i].split() newlines[i] += words[index-1] + " " - for i in xrange(len(newlines)): + for i in range(len(newlines)): newlines[i] += "\n" self.sections[name] = newlines @@ -206,7 +206,7 @@ class data: lines = self.sections[name] newlines = [] j = icol - 1 - for i in xrange(len(lines)): + for i in range(len(lines)): line = lines[i] words = line.split() words[j] = str(vector[i]) @@ -228,48 +228,48 @@ class data: self.replace("Atoms",self.names['x']+1,x) self.replace("Atoms",self.names['y']+1,y) self.replace("Atoms",self.names['z']+1,z) - - if dm.names.has_key("ix") and self.names.has_key("ix"): + + if "ix" in dm.names and "ix" in self.names: ix,iy,iz = dm.vecs(ntime,"ix","iy","iz") self.replace("Atoms",self.names['ix']+1,ix) self.replace("Atoms",self.names['iy']+1,iy) self.replace("Atoms",self.names['iz']+1,iz) - + # -------------------------------------------------------------------- # delete header value or section from data file def delete(self,keyword): - if self.headers.has_key(keyword): del self.headers[keyword] - elif self.sections.has_key(keyword): del self.sections[keyword] - else: raise StandardError, "keyword not found in data object" + if keyword in self.headers: del self.headers[keyword] + elif keyword in self.sections: del self.sections[keyword] + else: raise Exception("keyword not found in data object") # -------------------------------------------------------------------- # write out a LAMMPS data file def write(self,file): f = open(file,"w") - print >>f,self.title - + print(self.title, file=f) + # write any keywords in standard list hkeywords # in the order they are in hkeywords # then write any extra keywords at end of header section - + for keyword in hkeywords: - if self.headers.has_key(keyword): + if keyword in self.headers: if keyword == "xlo xhi" or keyword == "ylo yhi" or \ keyword == "zlo zhi": - pair = self.headers[keyword] - print >>f,pair[0],pair[1],keyword + pair = self.headers[keyword] + print(pair[0],pair[1],keyword, file=f) elif keyword == "xy xz yz": - triple = self.headers[keyword] - print >>f,triple[0],triple[1],triple[2],keyword + triple = self.headers[keyword] + print(triple[0],triple[1],triple[2],keyword, file=f) else: - print >>f,self.headers[keyword],keyword + print(self.headers[keyword],keyword, file=f) - for keyword in self.headers.keys(): + for keyword in list(self.headers.keys()): if keyword not in hkeywords: - print >>f,self.headers[keyword],keyword + print(self.headers[keyword],keyword, file=f) # write any sections in standard list skeywords # in the order they are in skeywords @@ -277,18 +277,18 @@ class data: for pair in skeywords: keyword = pair[0] - if self.sections.has_key(keyword): - print >>f,"\n%s\n" % keyword + if keyword in self.sections: + print("\n%s\n" % keyword, file=f) for line in self.sections[keyword]: - print >>f,line, + print(line, end='', file=f) skeyfirst = [pair[0] for pair in skeywords] - - for keyword in self.sections.keys(): + + for keyword in list(self.sections.keys()): if keyword not in skeyfirst: - print >>f,"\n%s\n" % keyword + print("\n%s\n" % keyword, file=f) for line in self.sections[keyword]: - print >>f,line, + print(line, end='', file=f) f.close() @@ -304,20 +304,20 @@ class data: def findtime(self,n): if n == 0: return 0 - raise StandardError, "no step %d exists" % (n) - + raise(Exception, "no step %d exists" % (n)) + # -------------------------------------------------------------------- # return list of atoms and bonds to viz for data object def viz(self,isnap): - if isnap: raise StandardError, "cannot call data.viz() with isnap != 0" - + if isnap: raise Exception("cannot call data.viz() with isnap != 0") + id = self.names["id"] type = self.names["type"] x = self.names["x"] y = self.names["y"] z = self.names["z"] - + xlohi = self.headers["xlo xhi"] ylohi = self.headers["ylo yhi"] zlohi = self.headers["zlo zhi"] @@ -336,7 +336,7 @@ class data: # assumes atoms are sorted so can lookup up the 2 atoms in each bond bonds = [] - if self.sections.has_key("Bonds"): + if "Bonds" in self.sections: bondlines = self.sections["Bonds"] for line in bondlines: words = line.split() @@ -349,8 +349,8 @@ class data: float(atom1words[z]), float(atom2words[x]),float(atom2words[y]), float(atom2words[z]), - float(atom1words[type]),float(atom2words[type])]) - + float(atom1words[type]),float(atom2words[type])]) + tris = [] lines = [] return 0,box,atoms,bonds,tris,lines @@ -375,8 +375,8 @@ class data: hkeywords = ["atoms","ellipsoids","lines","triangles","bodies", "bonds","angles","dihedrals","impropers", - "atom types","bond types","angle types","dihedral types", - "improper types", + "atom types","bond types","angle types","dihedral types", + "improper types", "xlo xhi","ylo yhi","zlo zhi","xy xz yz"] skeywords = [["Masses","atom types"], @@ -384,14 +384,14 @@ skeywords = [["Masses","atom types"], ["Lines","lines"],["Triangles","triangles"],["Bodies","bodies"], ["Velocities","atoms"], ["Bonds","bonds"], - ["Angles","angles"], + ["Angles","angles"], ["Dihedrals","dihedrals"], - ["Impropers","impropers"], + ["Impropers","impropers"], ["Pair Coeffs","atom types"], - ["Bond Coeffs","bond types"], + ["Bond Coeffs","bond types"], ["Angle Coeffs","angle types"], - ["Dihedral Coeffs","dihedral types"], - ["Improper Coeffs","improper types"], + ["Dihedral Coeffs","dihedral types"], + ["Improper Coeffs","improper types"], ["BondBond Coeffs","angle types"], ["BondAngle Coeffs","angle types"], ["MiddleBondTorsion Coeffs","dihedral types"], diff --git a/tools/tinker/tinker2lmp.py b/tools/tinker/tinker2lmp.py index 565d3f23fe..fe80be9a14 100644 --- a/tools/tinker/tinker2lmp.py +++ b/tools/tinker/tinker2lmp.py @@ -15,6 +15,7 @@ # Author: Steve Plimpton +from __future__ import print_function import sys,os,math from data import data @@ -29,20 +30,20 @@ DELTA = 0.001 # delta on LAMMPS shrink-wrap box size, in Angstroms def error(txt=""): if not txt: - print "Syntax: tinker2lmp.py -switch args ..." - print " -xyz file" - print " -amoeba file" - print " -hippo file" - print " -data file" - print " -bitorsion file" - print " -nopbc" - print " -pbc xhi yhi zhi" - else: print "ERROR:",txt + print("Syntax: tinker2lmp.py -switch args ...") + print(" -xyz file") + print(" -amoeba file") + print(" -hippo file") + print(" -data file") + print(" -bitorsion file") + print(" -nopbc") + print(" -pbc xhi yhi zhi") + else: print("ERROR:",txt) #sys.exit() # read and store values from a Tinker xyz file -class XYZfile: +class XYZfile(object): def __init__(self,file): lines = open(file,'r').readlines() header = lines[0] @@ -212,7 +213,7 @@ class XYZfile: def output(self,outfile): fp = open(outfile,'w') words = self.header.split() - print >>fp,self.natoms,"replicated",' '.join(words[1:]) + print(self.natoms,"replicated",' '.join(words[1:]), file=fp) id = self.id label = self.label @@ -225,9 +226,9 @@ class XYZfile: # NOTE: worry about formatting of line for i in range(self.natoms): - print >>fp,i+1,label[i],x[i],y[i],z[i],type[i], - for j in bonds[i]: print >>fp,j, - print >>fp + print(i+1,label[i],x[i],y[i],z[i],type[i], end=' ', file=fp) + for j in bonds[i]: print(j, end=' ', file=fp) + print(file=fp) fp.close() @@ -255,7 +256,7 @@ class XYZfile: # scalar force field params in Force Field Definition section # bond, angle, dihedral coeffs indexed by Tinker classes -class PRMfile: +class PRMfile(object): def __init__(self,file): lines = open(file,'r').readlines() self.nlines = len(lines) @@ -519,7 +520,7 @@ class PRMfile: error("torsion does not have triplets of params: %d %d %d %d" % \ (class1,class2,class3,class4)) - mfourier = (len(words)-5) / 3 + mfourier = int((len(words)-5)/3) oneparams = [class1,class2,class3,class4,mfourier] for iset in range(mfourier): @@ -743,7 +744,7 @@ if pbcflag: else: xlo = ylo = zlo = BIG xhi = yhi = zhi = -BIG - for i in xrange(natoms): + for i in range(natoms): xlo = min(xlo,float(x[i])) ylo = min(ylo,float(y[i])) zlo = min(zlo,float(z[i])) @@ -1097,11 +1098,11 @@ for i,one in enumerate(alist): nbonds,hcount = xyz.angle_hbond_count(atom1,atom2,atom3,lmptype,lmpmass) if nbonds != 3: - print "Center angle atom has wrong bond count" - print " angle atom IDs:",atom1,atom2,atom3 - print " angle atom classes:",c1,c2,c3 - print " Tinker FF file param options:",len(params[3]) - print " Nbonds and hydrogen count:",nbonds,hcount + print("Center angle atom has wrong bond count") + print(" angle atom IDs:",atom1,atom2,atom3) + print(" angle atom classes:",c1,c2,c3) + print(" Tinker FF file param options:",len(params[3])) + print(" Nbonds and hydrogen count:",nbonds,hcount) #sys.exit() NOTE: allow this for now if hcount == 0: which = 1 @@ -1109,22 +1110,22 @@ for i,one in enumerate(alist): which = 2 m += 1 - print "3-bond angle" - print " angle atom IDs:",atom1,atom2,atom3 - print " angle atom classes:",c1,c2,c3 - print " Tinker FF file param options:",len(params[3]) - print " Nbonds and hydrogen count:",nbonds,hcount - print " which:",which,m + print("3-bond angle") + print(" angle atom IDs:",atom1,atom2,atom3) + print(" angle atom classes:",c1,c2,c3) + print(" Tinker FF file param options:",len(params[3])) + print(" Nbonds and hydrogen count:",nbonds,hcount) + print(" which:",which,m) elif len(params[3]) == 3: nbonds,hcount = xyz.angle_hbond_count(atom1,atom2,atom3,lmptype,lmpmass) if nbonds != 4: - print "Center angle atom has wrong bond count" - print " angle atom IDs:",atom1,atom2,atom3 - print " angle atom classes:",c1,c2,c3 - print " Tinker FF file param options:",len(params[3]) - print " Nbonds and hydrogen count:",nbonds,hcount + print("Center angle atom has wrong bond count") + print(" angle atom IDs:",atom1,atom2,atom3) + print(" angle atom classes:",c1,c2,c3) + print(" Tinker FF file param options:",len(params[3])) + print(" Nbonds and hydrogen count:",nbonds,hcount) #sys.exit() NOTE: allow this for now if hcount == 0: which = 1 @@ -1170,7 +1171,7 @@ for itype in range(len(aparams)): elif (c3,c2,c1) in badict: n1,n2,r1,r2 = badict[(c3,c2,c1)] else: - print "Bond-stretch angle triplet not found: %d %d %d" % (c1,c2,c3) + print("Bond-stretch angle triplet not found: %d %d %d" % (c1,c2,c3)) n1,n2,r1,r2 = 4*[0.0] baparams.append((n1,n2,r1,r2)) @@ -1600,17 +1601,17 @@ if nbitorsions: nbitorsions) fp = open(bitorsionfile,'w') - print >>fp,"Tinker BiTorsion parameter file for fix bitorsion\n" - print >>fp,"%d bitorsion types" % len(bitorsionparams) + print("Tinker BiTorsion parameter file for fix bitorsion\n", file=fp) + print("%d bitorsion types" % len(bitorsionparams), file=fp) itype = 0 for nx,ny,array in bitorsionparams: itype += 1 - print >>fp - print >>fp,itype,nx,ny + print(file=fp) + print(itype,nx,ny, file=fp) for ix in range(nx): for iy in range(ny): xgrid,ygrid,value = array[ix][iy] - print >>fp," ",xgrid,ygrid,value + print(" ",xgrid,ygrid,value, file=fp) fp.close() lines = [] @@ -1624,21 +1625,21 @@ d.write(datafile) # print stats to screen -print "Natoms =",natoms -print "Ntypes =",ntypes -print "Tinker XYZ types =",len(tink2lmp) -print "Tinker PRM types =",prm.ntypes +print("Natoms =",natoms) +print("Ntypes =",ntypes) +print("Tinker XYZ types =",len(tink2lmp)) +print("Tinker PRM types =",prm.ntypes) #print "Tinker groups =",ngroups -print "Nmol =",nmol -print "Nbonds =",nbonds -print "Nangles =",nangles -print "Ndihedrals =",ndihedrals -print "Nimpropers =",nimpropers -print "Npitorsions =",npitorsions -print "Nbitorsions =",nbitorsions -print "Nbondtypes =",len(bparams) -print "Nangletypes =",len(aparams) -print "Ndihedraltypes =",len(dparams) -print "Nimpropertypes =",len(oparams) -print "Npitorsiontypes =",len(pitorsionparams) -print "Nbitorsiontypes =",len(bitorsionparams) +print("Nmol =",nmol) +print("Nbonds =",nbonds) +print("Nangles =",nangles) +print("Ndihedrals =",ndihedrals) +print("Nimpropers =",nimpropers) +print("Npitorsions =",npitorsions) +print("Nbitorsions =",nbitorsions) +print("Nbondtypes =",len(bparams)) +print("Nangletypes =",len(aparams)) +print("Ndihedraltypes =",len(dparams)) +print("Nimpropertypes =",len(oparams)) +print("Npitorsiontypes =",len(pitorsionparams)) +print("Nbitorsiontypes =",len(bitorsionparams)) From 378c5c168793e23cf585ab5eee8aea4c43908540 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 5 Jul 2022 11:03:48 -0400 Subject: [PATCH 533/585] silence compiler warnings --- src/AMOEBA/amoeba_file.cpp | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/src/AMOEBA/amoeba_file.cpp b/src/AMOEBA/amoeba_file.cpp index 77ea3ed774..ebedbc13d5 100644 --- a/src/AMOEBA/amoeba_file.cpp +++ b/src/AMOEBA/amoeba_file.cpp @@ -847,7 +847,7 @@ void PairAmoeba::file_ffield(const std::vector &words, int nline) /* ---------------------------------------------------------------------- */ -void PairAmoeba::file_literature(const std::vector &words, int /*nline*/) +void PairAmoeba::file_literature(const std::vector & /*words*/, int /*nline*/) { // do nothing, this section is skipped } @@ -1185,7 +1185,7 @@ void PairAmoeba::file_charge_penetration(const std::vector &words, void PairAmoeba::file_dippolar(const std::vector &words, int nline) { - const int ndipparams = amoeba ? 4 : 3; + const std::size_t ndipparams = amoeba ? 4 : 3; if (words[0] != "polarize") error->all(FLERR, "{} PRM file dipole polariability line {} has invalid format: {}", utils::uppercase(mystyle), nline, utils::join_words(words, " ")); From 67e29fc76683dc9cc846d47b89df8b6835f3e352 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 5 Jul 2022 11:20:15 -0400 Subject: [PATCH 534/585] add metadata tags to the .key files too. --- examples/amoeba/amoeba_ubiquitin.key | 1 + examples/amoeba/amoeba_water.key | 5 ++- examples/amoeba/amoeba_water_box.key | 4 +- examples/amoeba/hippo_water.key | 5 ++- examples/amoeba/hippo_water_box.key | 4 +- examples/amoeba/log.5Jul22.ubiquitin.g++.1 | 33 +++++++++-------- examples/amoeba/log.5Jul22.ubiquitin.g++.4 | 31 ++++++++-------- .../amoeba/log.5Jul22.water_box.amoeba.g++.1 | 37 ++++++++++--------- .../amoeba/log.5Jul22.water_box.amoeba.g++.4 | 33 +++++++++-------- .../amoeba/log.5Jul22.water_box.hippo.g++.1 | 33 +++++++++-------- .../amoeba/log.5Jul22.water_box.hippo.g++.4 | 37 ++++++++++--------- .../log.5Jul22.water_dimer.amoeba.g++.1 | 31 ++++++++-------- .../log.5Jul22.water_dimer.amoeba.g++.4 | 33 +++++++++-------- .../amoeba/log.5Jul22.water_dimer.hippo.g++.1 | 35 +++++++++--------- .../amoeba/log.5Jul22.water_dimer.hippo.g++.4 | 35 +++++++++--------- .../log.5Jul22.water_hexamer.amoeba.g++.1 | 31 ++++++++-------- .../log.5Jul22.water_hexamer.amoeba.g++.4 | 29 ++++++++------- .../log.5Jul22.water_hexamer.hippo.g++.1 | 35 +++++++++--------- .../log.5Jul22.water_hexamer.hippo.g++.4 | 35 +++++++++--------- 19 files changed, 252 insertions(+), 235 deletions(-) diff --git a/examples/amoeba/amoeba_ubiquitin.key b/examples/amoeba/amoeba_ubiquitin.key index db0a23c950..2870d071d4 100644 --- a/examples/amoeba/amoeba_ubiquitin.key +++ b/examples/amoeba/amoeba_ubiquitin.key @@ -1,3 +1,4 @@ +!! DATE: 2022-07-05 UNITS: real parameters ./amoeba.prm verbose neighbor-list diff --git a/examples/amoeba/amoeba_water.key b/examples/amoeba/amoeba_water.key index 8222179c52..9cfe063db1 100644 --- a/examples/amoeba/amoeba_water.key +++ b/examples/amoeba/amoeba_water.key @@ -1,4 +1,5 @@ -parameters ./amoeba.prm +!! DATE: 2022-07-05 UNITS: real +parameters ./amoeba.prm digits 8 @@ -6,4 +7,4 @@ cutoff 10 taper 8 polar-eps 1e-5 -usolve-diag 1.0 \ No newline at end of file +usolve-diag 1.0 diff --git a/examples/amoeba/amoeba_water_box.key b/examples/amoeba/amoeba_water_box.key index b74edf324a..94c9808875 100644 --- a/examples/amoeba/amoeba_water_box.key +++ b/examples/amoeba/amoeba_water_box.key @@ -1,4 +1,5 @@ -parameters ./amoeba.prm +!! DATE: 2022-07-05 UNITS: real +parameters ./amoeba.prm digits 10 openmp-threads 1 @@ -16,4 +17,3 @@ taper 6 polar-eps 1e-5 usolve-diag 1.0 - diff --git a/examples/amoeba/hippo_water.key b/examples/amoeba/hippo_water.key index a61b83875b..1b509c2276 100644 --- a/examples/amoeba/hippo_water.key +++ b/examples/amoeba/hippo_water.key @@ -1,4 +1,5 @@ -parameters ./hippo.prm +!! DATE: 2022-07-05 UNITS: real +parameters ./hippo.prm digits 8 @@ -6,4 +7,4 @@ cutoff 10 taper 8 polar-eps 1e-5 -usolve-diag 1.0 \ No newline at end of file +usolve-diag 1.0 diff --git a/examples/amoeba/hippo_water_box.key b/examples/amoeba/hippo_water_box.key index 1dd89919ed..24710cb465 100644 --- a/examples/amoeba/hippo_water_box.key +++ b/examples/amoeba/hippo_water_box.key @@ -1,4 +1,5 @@ -parameters ./hippo.prm +!! DATE: 2022-07-05 UNITS: real +parameters ./hippo.prm digits 8 verbose @@ -19,4 +20,3 @@ taper 6 polar-eps 1e-5 usolve-diag 1.0 - diff --git a/examples/amoeba/log.5Jul22.ubiquitin.g++.1 b/examples/amoeba/log.5Jul22.ubiquitin.g++.1 index 74019ccdf9..161b74167c 100644 --- a/examples/amoeba/log.5Jul22.ubiquitin.g++.1 +++ b/examples/amoeba/log.5Jul22.ubiquitin.g++.1 @@ -57,7 +57,7 @@ Finding 1-2 1-3 1-4 neighbors ... 19 = max # of 1-4 neighbors 21 = max # of special neighbors special bonds CPU = 0.003 seconds - read_data CPU = 0.077 seconds + read_data CPU = 0.040 seconds pair_style amoeba pair_coeff * * amoeba_ubiquitin.prm amoeba_ubiquitin.key @@ -65,6 +65,7 @@ Reading potential file amoeba_ubiquitin.prm with DATE: 2022-07-05 Skipping section: AMOEBA Protein Force Field Atom Classes Skipping section: Torsion-Torsion Parameters Skipping section: Biopolymer Atom Type Conversions +Reading potential file amoeba_ubiquitin.key with DATE: 2022-07-05 special_bonds lj/coul 0.5 0.5 0.5 one/five yes Finding 1-2 1-3 1-4 neighbors ... @@ -75,7 +76,7 @@ Finding 1-2 1-3 1-4 neighbors ... 19 = max # of 1-4 neighbors 58 = max # of 1-5 neighbors 21 = max # of special neighbors - special bonds CPU = 0.005 seconds + special bonds CPU = 0.004 seconds # thermo output @@ -124,29 +125,29 @@ Per MPI rank memory allocation (min/avg/max) = 258.3 | 258.3 | 258.3 Mbytes 3 88.8921 -35402.11 938.99299 1162.2914 220.5271 58.832521 2380.644 -30453.516 -1929.5417 -3331.1291 -2769.7218 -3350.5733 117.32302 279.72705 31.237776 4 68.740402 -35477.589 2048.0659 858.03795 218.14277 54.460022 3178.7066 -30316.325 2041.1138 594.25938 1665.7799 1030.8539 66.230421 304.28296 -155.80224 5 76.267862 -35707.869 2206.6534 736.37385 215.75693 49.401674 3208.1859 -30299.377 2276.9276 536.21124 1893.4621 1258.492 92.097191 299.65604 -228.58369 -Loop time of 6.65546 on 1 procs for 5 steps with 9737 atoms +Loop time of 6.44802 on 1 procs for 5 steps with 9737 atoms -Performance: 0.065 ns/day, 369.748 hours/ns, 0.751 timesteps/s +Performance: 0.067 ns/day, 358.224 hours/ns, 0.775 timesteps/s 99.8% CPU use with 1 MPI tasks x 1 OpenMP threads AMOEBA timing breakdown: - Init time: 0.0105468 0.16% - Hal time: 1.57051 23.62% - Mpole time: 0.805631 12.12% - Induce time: 2.69099 40.48% - Polar time: 1.57015 23.62% - Total time: 6.64783 + Init time: 0.0102334 0.16% + Hal time: 1.53439 23.82% + Mpole time: 0.799674 12.42% + Induce time: 2.57766 40.02% + Polar time: 1.51886 23.58% + Total time: 6.44082 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 6.6478 | 6.6478 | 6.6478 | 0.0 | 99.89 -Bond | 0.0052138 | 0.0052138 | 0.0052138 | 0.0 | 0.08 +Pair | 6.4408 | 6.4408 | 6.4408 | 0.0 | 99.89 +Bond | 0.0049681 | 0.0049681 | 0.0049681 | 0.0 | 0.08 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.0010535 | 0.0010535 | 0.0010535 | 0.0 | 0.02 -Output | 0.00033674 | 0.00033674 | 0.00033674 | 0.0 | 0.01 -Modify | 0.00085639 | 0.00085639 | 0.00085639 | 0.0 | 0.01 -Other | | 0.000145 | | | 0.00 +Comm | 0.00097251 | 0.00097251 | 0.00097251 | 0.0 | 0.02 +Output | 0.00031789 | 0.00031789 | 0.00031789 | 0.0 | 0.00 +Modify | 0.00080532 | 0.00080532 | 0.00080532 | 0.0 | 0.01 +Other | | 0.0001288 | | | 0.00 Nlocal: 9737 ave 9737 max 9737 min Histogram: 1 0 0 0 0 0 0 0 0 0 diff --git a/examples/amoeba/log.5Jul22.ubiquitin.g++.4 b/examples/amoeba/log.5Jul22.ubiquitin.g++.4 index fed3f9896e..b337dae759 100644 --- a/examples/amoeba/log.5Jul22.ubiquitin.g++.4 +++ b/examples/amoeba/log.5Jul22.ubiquitin.g++.4 @@ -57,7 +57,7 @@ Finding 1-2 1-3 1-4 neighbors ... 19 = max # of 1-4 neighbors 21 = max # of special neighbors special bonds CPU = 0.001 seconds - read_data CPU = 0.036 seconds + read_data CPU = 0.062 seconds pair_style amoeba pair_coeff * * amoeba_ubiquitin.prm amoeba_ubiquitin.key @@ -65,6 +65,7 @@ Reading potential file amoeba_ubiquitin.prm with DATE: 2022-07-05 Skipping section: AMOEBA Protein Force Field Atom Classes Skipping section: Torsion-Torsion Parameters Skipping section: Biopolymer Atom Type Conversions +Reading potential file amoeba_ubiquitin.key with DATE: 2022-07-05 special_bonds lj/coul 0.5 0.5 0.5 one/five yes Finding 1-2 1-3 1-4 neighbors ... @@ -124,29 +125,29 @@ Per MPI rank memory allocation (min/avg/max) = 144.2 | 144.7 | 145.4 Mbytes 3 88.8921 -35402.11 938.99299 1162.2914 220.5271 58.832521 2380.644 -30453.516 -1929.5417 -3331.1291 -2769.7218 -3350.5733 117.32302 279.72705 31.237776 4 68.740402 -35477.589 2048.0659 858.03795 218.14277 54.460022 3178.7066 -30316.325 2041.1138 594.25938 1665.7799 1030.8539 66.230421 304.28296 -155.80224 5 76.267862 -35707.869 2206.6534 736.37385 215.75693 49.401674 3208.1859 -30299.377 2276.9276 536.21124 1893.4621 1258.492 92.097191 299.65604 -228.58369 -Loop time of 2.1516 on 4 procs for 5 steps with 9737 atoms +Loop time of 2.1567 on 4 procs for 5 steps with 9737 atoms -Performance: 0.201 ns/day, 119.533 hours/ns, 2.324 timesteps/s +Performance: 0.200 ns/day, 119.817 hours/ns, 2.318 timesteps/s 99.4% CPU use with 4 MPI tasks x 1 OpenMP threads AMOEBA timing breakdown: - Init time: 0.0116891 0.54% - Hal time: 0.423411 19.72% - Mpole time: 0.269917 12.57% - Induce time: 0.929983 43.30% - Polar time: 0.512586 23.87% - Total time: 2.14759 + Init time: 0.0115153 0.53% + Hal time: 0.445713 20.70% + Mpole time: 0.282302 13.11% + Induce time: 0.90538 42.06% + Polar time: 0.507821 23.59% + Total time: 2.15273 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 2.1477 | 2.1477 | 2.1477 | 0.0 | 99.82 -Bond | 0.001184 | 0.0014529 | 0.0016771 | 0.5 | 0.07 +Pair | 2.1527 | 2.1528 | 2.1529 | 0.0 | 99.82 +Bond | 0.0012019 | 0.0014482 | 0.0016726 | 0.4 | 0.07 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.0015356 | 0.0017027 | 0.001922 | 0.4 | 0.08 -Output | 0.00027025 | 0.0003219 | 0.00040484 | 0.0 | 0.01 -Modify | 0.00028633 | 0.00030716 | 0.00032386 | 0.0 | 0.01 -Other | | 0.0001328 | | | 0.01 +Comm | 0.0015211 | 0.0016953 | 0.0019541 | 0.4 | 0.08 +Output | 0.00024653 | 0.00030686 | 0.0003922 | 0.0 | 0.01 +Modify | 0.00028632 | 0.00030747 | 0.00033879 | 0.0 | 0.01 +Other | | 0.0001387 | | | 0.01 Nlocal: 2434.25 ave 2498 max 2390 min Histogram: 1 1 0 0 1 0 0 0 0 1 diff --git a/examples/amoeba/log.5Jul22.water_box.amoeba.g++.1 b/examples/amoeba/log.5Jul22.water_box.amoeba.g++.1 index 23b9fee06f..acf5cd5dba 100644 --- a/examples/amoeba/log.5Jul22.water_box.amoeba.g++.1 +++ b/examples/amoeba/log.5Jul22.water_box.amoeba.g++.1 @@ -40,14 +40,15 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-3 neighbors 1 = max # of 1-4 neighbors 2 = max # of special neighbors - special bonds CPU = 0.001 seconds - read_data CPU = 0.012 seconds + special bonds CPU = 0.000 seconds + read_data CPU = 0.004 seconds # force field pair_style amoeba pair_coeff * * amoeba_water.prm amoeba_water_box.key Reading potential file amoeba_water.prm with DATE: 2022-07-05 +Reading potential file amoeba_water_box.key with DATE: 2022-07-05 special_bonds lj/coul 0.5 0.5 0.5 one/five yes Finding 1-2 1-3 1-4 neighbors ... @@ -58,7 +59,7 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of 1-5 neighbors 2 = max # of special neighbors - special bonds CPU = 0.001 seconds + special bonds CPU = 0.000 seconds # thermo output @@ -112,29 +113,29 @@ Per MPI rank memory allocation (min/avg/max) = 56.94 | 56.94 | 56.94 Mbytes 80 171.83506 -2388.0612 76.465932 49.1299 0 0 125.59583 -1931.067 2210.3658 -318.23867 330.74353 -395.26693 -43.142216 252.53012 -1987.0412 90 175.73401 -2423.8154 90.786573 63.719496 0 0 154.50607 -1930.3915 -916.91571 -3942.3954 -2566.5361 -3414.8202 199.82369 2365.9443 -266.38604 100 173.72684 -2422.367 99.75941 57.294464 0 0 157.05387 -1930.2663 -3585.8356 -5734.1341 -5882.0146 -6232.4353 -227.79935 959.68225 404.47924 -Loop time of 9.23157 on 1 procs for 100 steps with 648 atoms +Loop time of 9.13006 on 1 procs for 100 steps with 648 atoms -Performance: 0.936 ns/day, 25.643 hours/ns, 10.832 timesteps/s +Performance: 0.946 ns/day, 25.361 hours/ns, 10.953 timesteps/s 99.8% CPU use with 1 MPI tasks x 1 OpenMP threads AMOEBA timing breakdown: - Init time: 0.0194993 0.21% - Hal time: 0.383028 4.15% - Mpole time: 0.935775 10.15% - Induce time: 6.06306 65.76% - Polar time: 1.81839 19.72% - Total time: 9.21978 + Init time: 0.0195637 0.21% + Hal time: 0.383019 4.20% + Mpole time: 0.942757 10.34% + Induce time: 5.97653 65.54% + Polar time: 1.79658 19.70% + Total time: 9.11849 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 9.2201 | 9.2201 | 9.2201 | 0.0 | 99.88 -Bond | 0.0024949 | 0.0024949 | 0.0024949 | 0.0 | 0.03 -Neigh | 0.0046051 | 0.0046051 | 0.0046051 | 0.0 | 0.05 -Comm | 0.0023611 | 0.0023611 | 0.0023611 | 0.0 | 0.03 -Output | 0.00045516 | 0.00045516 | 0.00045516 | 0.0 | 0.00 -Modify | 0.00070554 | 0.00070554 | 0.00070554 | 0.0 | 0.01 -Other | | 0.0008327 | | | 0.01 +Pair | 9.1188 | 9.1188 | 9.1188 | 0.0 | 99.88 +Bond | 0.0025049 | 0.0025049 | 0.0025049 | 0.0 | 0.03 +Neigh | 0.0045289 | 0.0045289 | 0.0045289 | 0.0 | 0.05 +Comm | 0.0022625 | 0.0022625 | 0.0022625 | 0.0 | 0.02 +Output | 0.00044299 | 0.00044299 | 0.00044299 | 0.0 | 0.00 +Modify | 0.00069998 | 0.00069998 | 0.00069998 | 0.0 | 0.01 +Other | | 0.0008232 | | | 0.01 Nlocal: 648 ave 648 max 648 min Histogram: 1 0 0 0 0 0 0 0 0 0 diff --git a/examples/amoeba/log.5Jul22.water_box.amoeba.g++.4 b/examples/amoeba/log.5Jul22.water_box.amoeba.g++.4 index 1db1f9abee..a4ddd2f637 100644 --- a/examples/amoeba/log.5Jul22.water_box.amoeba.g++.4 +++ b/examples/amoeba/log.5Jul22.water_box.amoeba.g++.4 @@ -41,13 +41,14 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of special neighbors special bonds CPU = 0.000 seconds - read_data CPU = 0.005 seconds + read_data CPU = 0.008 seconds # force field pair_style amoeba pair_coeff * * amoeba_water.prm amoeba_water_box.key Reading potential file amoeba_water.prm with DATE: 2022-07-05 +Reading potential file amoeba_water_box.key with DATE: 2022-07-05 special_bonds lj/coul 0.5 0.5 0.5 one/five yes Finding 1-2 1-3 1-4 neighbors ... @@ -112,29 +113,29 @@ Per MPI rank memory allocation (min/avg/max) = 56.38 | 56.38 | 56.38 Mbytes 80 171.83506 -2388.0612 76.465932 49.1299 0 0 125.59583 -1931.067 2210.3658 -318.23867 330.74353 -395.26693 -43.142216 252.53012 -1987.0412 90 175.73401 -2423.8154 90.786573 63.719496 0 0 154.50607 -1930.3915 -916.91571 -3942.3954 -2566.5361 -3414.8202 199.82369 2365.9443 -266.38604 100 173.72684 -2422.367 99.75941 57.294464 0 0 157.05387 -1930.2663 -3585.8356 -5734.1341 -5882.0146 -6232.4353 -227.79935 959.68225 404.47924 -Loop time of 3.62992 on 4 procs for 100 steps with 648 atoms +Loop time of 3.55068 on 4 procs for 100 steps with 648 atoms -Performance: 2.380 ns/day, 10.083 hours/ns, 27.549 timesteps/s +Performance: 2.433 ns/day, 9.863 hours/ns, 28.164 timesteps/s 99.3% CPU use with 4 MPI tasks x 1 OpenMP threads AMOEBA timing breakdown: - Init time: 0.0211291 0.58% - Hal time: 0.114718 3.17% - Mpole time: 0.329891 9.11% - Induce time: 2.5339 69.99% - Polar time: 0.620639 17.14% - Total time: 3.6203 + Init time: 0.0212328 0.60% + Hal time: 0.112487 3.18% + Mpole time: 0.322738 9.11% + Induce time: 2.47321 69.83% + Polar time: 0.611925 17.28% + Total time: 3.54162 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 3.6209 | 3.621 | 3.6211 | 0.0 | 99.75 -Bond | 0.00085544 | 0.00087038 | 0.00090469 | 0.0 | 0.02 -Neigh | 0.0014354 | 0.0014405 | 0.0014453 | 0.0 | 0.04 -Comm | 0.004823 | 0.0048746 | 0.0049092 | 0.0 | 0.13 -Output | 0.00038727 | 0.00043628 | 0.00055233 | 0.0 | 0.01 -Modify | 0.00033814 | 0.0003491 | 0.00037267 | 0.0 | 0.01 -Other | | 0.0009691 | | | 0.03 +Pair | 3.5421 | 3.5423 | 3.5425 | 0.0 | 99.76 +Bond | 0.00080566 | 0.00088074 | 0.00099188 | 0.0 | 0.02 +Neigh | 0.0014246 | 0.0014359 | 0.0014469 | 0.0 | 0.04 +Comm | 0.0043463 | 0.0045083 | 0.0046393 | 0.2 | 0.13 +Output | 0.00035535 | 0.00039745 | 0.00051597 | 0.0 | 0.01 +Modify | 0.00034241 | 0.00035548 | 0.00036576 | 0.0 | 0.01 +Other | | 0.0008093 | | | 0.02 Nlocal: 162 ave 164 max 159 min Histogram: 1 0 0 0 0 0 1 0 1 1 diff --git a/examples/amoeba/log.5Jul22.water_box.hippo.g++.1 b/examples/amoeba/log.5Jul22.water_box.hippo.g++.1 index 1c998687f4..c398031b24 100644 --- a/examples/amoeba/log.5Jul22.water_box.hippo.g++.1 +++ b/examples/amoeba/log.5Jul22.water_box.hippo.g++.1 @@ -48,6 +48,7 @@ Finding 1-2 1-3 1-4 neighbors ... pair_style hippo pair_coeff * * hippo_water.prm hippo_water_box.key Reading potential file hippo_water.prm with DATE: 2022-07-05 +Reading potential file hippo_water_box.key with DATE: 2022-07-05 special_bonds lj/coul 0.5 0.5 0.5 one/five yes Finding 1-2 1-3 1-4 neighbors ... @@ -109,31 +110,31 @@ Per MPI rank memory allocation (min/avg/max) = 56.46 | 56.46 | 56.46 Mbytes 3 83.751912 -2189.1561 36.936027 32.349803 0 0 69.285831 -1958.3477 1505.3642 2789.4989 -1919.6532 227.71216 3.4467207 240.18575 -91.250567 4 59.186129 -2195.3882 116.40559 17.314099 0 0 133.71969 -1947.5231 7666.6109 9441.7634 4355.1915 6787.0543 329.33631 -768.83277 -966.66638 5 70.911532 -2215.1422 115.71443 14.75745 0 0 130.47188 -1947.9114 7292.9034 8506.6309 4019.0295 6458.6256 348.80878 -911.32703 -1060.6123 -Loop time of 0.326218 on 1 procs for 5 steps with 648 atoms +Loop time of 0.328535 on 1 procs for 5 steps with 648 atoms -Performance: 1.324 ns/day, 18.123 hours/ns, 15.327 timesteps/s +Performance: 1.315 ns/day, 18.252 hours/ns, 15.219 timesteps/s 99.8% CPU use with 1 MPI tasks x 1 OpenMP threads HIPPO timing breakdown: - Init time: 0.000842282 0.26% - Repulse time: 0.0383544 11.78% - Disp time: 0.0173558 5.33% - Mpole time: 0.0613861 18.85% - Induce time: 0.121337 37.26% - Polar time: 0.0763061 23.43% - Qxfer time: 0.0101016 3.10% - Total time: 0.325683 + Init time: 0.000827146 0.25% + Repulse time: 0.0383201 11.68% + Disp time: 0.0174221 5.31% + Mpole time: 0.0612574 18.67% + Induce time: 0.123563 37.67% + Polar time: 0.076967 23.46% + Qxfer time: 0.00966432 2.95% + Total time: 0.328021 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.3257 | 0.3257 | 0.3257 | 0.0 | 99.84 -Bond | 0.00013737 | 0.00013737 | 0.00013737 | 0.0 | 0.04 +Pair | 0.32803 | 0.32803 | 0.32803 | 0.0 | 99.85 +Bond | 0.00013553 | 0.00013553 | 0.00013553 | 0.0 | 0.04 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.0001122 | 0.0001122 | 0.0001122 | 0.0 | 0.03 -Output | 0.00020981 | 0.00020981 | 0.00020981 | 0.0 | 0.06 -Modify | 3.4058e-05 | 3.4058e-05 | 3.4058e-05 | 0.0 | 0.01 -Other | | 2.595e-05 | | | 0.01 +Comm | 8.9842e-05 | 8.9842e-05 | 8.9842e-05 | 0.0 | 0.03 +Output | 0.00021433 | 0.00021433 | 0.00021433 | 0.0 | 0.07 +Modify | 3.4997e-05 | 3.4997e-05 | 3.4997e-05 | 0.0 | 0.01 +Other | | 2.511e-05 | | | 0.01 Nlocal: 648 ave 648 max 648 min Histogram: 1 0 0 0 0 0 0 0 0 0 diff --git a/examples/amoeba/log.5Jul22.water_box.hippo.g++.4 b/examples/amoeba/log.5Jul22.water_box.hippo.g++.4 index 80730c0301..35b8e2bd9b 100644 --- a/examples/amoeba/log.5Jul22.water_box.hippo.g++.4 +++ b/examples/amoeba/log.5Jul22.water_box.hippo.g++.4 @@ -41,13 +41,14 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of special neighbors special bonds CPU = 0.000 seconds - read_data CPU = 0.007 seconds + read_data CPU = 0.005 seconds # force field pair_style hippo pair_coeff * * hippo_water.prm hippo_water_box.key Reading potential file hippo_water.prm with DATE: 2022-07-05 +Reading potential file hippo_water_box.key with DATE: 2022-07-05 special_bonds lj/coul 0.5 0.5 0.5 one/five yes Finding 1-2 1-3 1-4 neighbors ... @@ -109,31 +110,31 @@ Per MPI rank memory allocation (min/avg/max) = 55.94 | 55.94 | 55.94 Mbytes 3 83.751912 -2189.1561 36.936027 32.349803 0 0 69.285831 -1958.3477 1505.3642 2789.4989 -1919.6532 227.71216 3.4467207 240.18575 -91.250567 4 59.186129 -2195.3882 116.40559 17.314099 0 0 133.71969 -1947.5231 7666.6109 9441.7634 4355.1915 6787.0543 329.33631 -768.83277 -966.66638 5 70.911532 -2215.1422 115.71443 14.75745 0 0 130.47188 -1947.9114 7292.9034 8506.6309 4019.0295 6458.6256 348.80878 -911.32703 -1060.6123 -Loop time of 0.122 on 4 procs for 5 steps with 648 atoms +Loop time of 0.122575 on 4 procs for 5 steps with 648 atoms -Performance: 3.541 ns/day, 6.778 hours/ns, 40.984 timesteps/s -98.6% CPU use with 4 MPI tasks x 1 OpenMP threads +Performance: 3.524 ns/day, 6.810 hours/ns, 40.792 timesteps/s +99.2% CPU use with 4 MPI tasks x 1 OpenMP threads HIPPO timing breakdown: - Init time: 0.000810221 0.67% - Repulse time: 0.0125366 10.36% - Disp time: 0.00623213 5.15% - Mpole time: 0.0210595 17.40% - Induce time: 0.0506279 41.83% - Polar time: 0.026832 22.17% - Qxfer time: 0.00292863 2.42% - Total time: 0.121027 + Init time: 0.000860363 0.71% + Repulse time: 0.0125286 10.32% + Disp time: 0.00643959 5.30% + Mpole time: 0.0212485 17.50% + Induce time: 0.0494722 40.74% + Polar time: 0.0278425 22.93% + Qxfer time: 0.00305419 2.51% + Total time: 0.121446 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.12089 | 0.12109 | 0.12131 | 0.0 | 99.25 -Bond | 4.8642e-05 | 5.2114e-05 | 6.0555e-05 | 0.0 | 0.04 +Pair | 0.12142 | 0.12151 | 0.12158 | 0.0 | 99.13 +Bond | 6.0063e-05 | 6.7176e-05 | 7.9312e-05 | 0.0 | 0.05 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.00035781 | 0.00058015 | 0.00076608 | 0.0 | 0.48 -Output | 0.0001878 | 0.00022879 | 0.00026441 | 0.0 | 0.19 -Modify | 1.7668e-05 | 1.8481e-05 | 1.9751e-05 | 0.0 | 0.02 -Other | | 3.389e-05 | | | 0.03 +Comm | 0.00042855 | 0.00057228 | 0.00067923 | 0.0 | 0.47 +Output | 0.00031594 | 0.00036048 | 0.0004471 | 0.0 | 0.29 +Modify | 3.0303e-05 | 3.1698e-05 | 3.2468e-05 | 0.0 | 0.03 +Other | | 3.774e-05 | | | 0.03 Nlocal: 162 ave 166 max 159 min Histogram: 2 0 0 0 0 0 0 1 0 1 diff --git a/examples/amoeba/log.5Jul22.water_dimer.amoeba.g++.1 b/examples/amoeba/log.5Jul22.water_dimer.amoeba.g++.1 index c9aa2ba0a1..a6f5fd1f0d 100644 --- a/examples/amoeba/log.5Jul22.water_dimer.amoeba.g++.1 +++ b/examples/amoeba/log.5Jul22.water_dimer.amoeba.g++.1 @@ -48,6 +48,7 @@ Finding 1-2 1-3 1-4 neighbors ... pair_style amoeba pair_coeff * * amoeba_water.prm amoeba_water.key Reading potential file amoeba_water.prm with DATE: 2022-07-05 +Reading potential file amoeba_water.key with DATE: 2022-07-05 special_bonds lj/coul 0.5 0.5 0.5 one/five yes Finding 1-2 1-3 1-4 neighbors ... @@ -108,29 +109,29 @@ Per MPI rank memory allocation (min/avg/max) = 48.33 | 48.33 | 48.33 Mbytes 3 22.599529 -5.0641035 0.0093422156 0.28736734 0 0 0.29670956 -4.4305695 7832.024 -6436.638 34275.274 -8676.6339 -46.038158 -20245.105 -46.202354 4 30.447598 -5.0072832 0.0076827791 0.11282886 0 0 0.12051164 -4.432979 12374.854 6652.5061 24658.364 -25.4576 -23.025707 -13137.295 -27.801932 5 33.189086 -4.9523094 0.0086012541 0.015399005 0 0 0.024000259 -4.4336573 10023.674 11810.883 8754.5769 3140.658 0.25267021 -3546.6216 -6.83205 -Loop time of 0.000214688 on 1 procs for 5 steps with 6 atoms +Loop time of 0.000215006 on 1 procs for 5 steps with 6 atoms -Performance: 2012.222 ns/day, 0.012 hours/ns, 23289.611 timesteps/s -65.7% CPU use with 1 MPI tasks x 1 OpenMP threads +Performance: 2009.246 ns/day, 0.012 hours/ns, 23255.165 timesteps/s +78.1% CPU use with 1 MPI tasks x 1 OpenMP threads AMOEBA timing breakdown: - Init time: 5.306e-06 4.54% - Hal time: 6.681e-06 5.72% - Mpole time: 1.6221e-05 13.88% - Induce time: 5.6723e-05 48.54% - Polar time: 3.1532e-05 26.98% - Total time: 0.000116854 + Init time: 5.213e-06 4.42% + Hal time: 6.546e-06 5.55% + Mpole time: 1.5909e-05 13.48% + Induce time: 5.8305e-05 49.39% + Polar time: 3.1695e-05 26.85% + Total time: 0.000118041 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.00011888 | 0.00011888 | 0.00011888 | 0.0 | 55.37 -Bond | 3.797e-06 | 3.797e-06 | 3.797e-06 | 0.0 | 1.77 +Pair | 0.00011999 | 0.00011999 | 0.00011999 | 0.0 | 55.81 +Bond | 3.429e-06 | 3.429e-06 | 3.429e-06 | 0.0 | 1.59 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 7.24e-07 | 7.24e-07 | 7.24e-07 | 0.0 | 0.34 -Output | 8.4738e-05 | 8.4738e-05 | 8.4738e-05 | 0.0 | 39.47 -Modify | 1.53e-06 | 1.53e-06 | 1.53e-06 | 0.0 | 0.71 -Other | | 5.022e-06 | | | 2.34 +Comm | 6.69e-07 | 6.69e-07 | 6.69e-07 | 0.0 | 0.31 +Output | 8.4574e-05 | 8.4574e-05 | 8.4574e-05 | 0.0 | 39.34 +Modify | 1.595e-06 | 1.595e-06 | 1.595e-06 | 0.0 | 0.74 +Other | | 4.744e-06 | | | 2.21 Nlocal: 6 ave 6 max 6 min Histogram: 1 0 0 0 0 0 0 0 0 0 diff --git a/examples/amoeba/log.5Jul22.water_dimer.amoeba.g++.4 b/examples/amoeba/log.5Jul22.water_dimer.amoeba.g++.4 index 94901fdf24..965cc5f5e5 100644 --- a/examples/amoeba/log.5Jul22.water_dimer.amoeba.g++.4 +++ b/examples/amoeba/log.5Jul22.water_dimer.amoeba.g++.4 @@ -41,13 +41,14 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of special neighbors special bonds CPU = 0.000 seconds - read_data CPU = 0.004 seconds + read_data CPU = 0.003 seconds # force field pair_style amoeba pair_coeff * * amoeba_water.prm amoeba_water.key Reading potential file amoeba_water.prm with DATE: 2022-07-05 +Reading potential file amoeba_water.key with DATE: 2022-07-05 special_bonds lj/coul 0.5 0.5 0.5 one/five yes Finding 1-2 1-3 1-4 neighbors ... @@ -108,29 +109,29 @@ Per MPI rank memory allocation (min/avg/max) = 48.35 | 48.48 | 48.62 Mbytes 3 22.599529 -5.0641035 0.0093422156 0.28736734 0 0 0.29670956 -4.4305695 7832.024 -6436.638 34275.274 -8676.6339 -46.038158 -20245.105 -46.202354 4 30.447598 -5.0072832 0.0076827791 0.11282886 0 0 0.12051164 -4.432979 12374.854 6652.5061 24658.364 -25.4576 -23.025707 -13137.295 -27.801932 5 33.189086 -4.9523094 0.0086012541 0.015399005 0 0 0.024000259 -4.4336573 10023.674 11810.883 8754.5769 3140.658 0.25267021 -3546.6216 -6.83205 -Loop time of 0.000598353 on 4 procs for 5 steps with 6 atoms +Loop time of 0.000514756 on 4 procs for 5 steps with 6 atoms -Performance: 721.982 ns/day, 0.033 hours/ns, 8356.278 timesteps/s -98.9% CPU use with 4 MPI tasks x 1 OpenMP threads +Performance: 839.232 ns/day, 0.029 hours/ns, 9713.335 timesteps/s +99.0% CPU use with 4 MPI tasks x 1 OpenMP threads AMOEBA timing breakdown: - Init time: 1.3678e-05 3.81% - Hal time: 3.5045e-06 0.97% - Mpole time: 2.3748e-05 6.61% - Induce time: 0.000284514 79.15% - Polar time: 3.3521e-05 9.33% - Total time: 0.000359445 + Init time: 1.1899e-05 3.41% + Hal time: 2.53025e-06 0.73% + Mpole time: 1.78605e-05 5.12% + Induce time: 0.000291075 83.49% + Polar time: 2.47857e-05 7.11% + Total time: 0.000348626 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.00035282 | 0.00038565 | 0.00040584 | 0.0 | 64.45 -Bond | 1.637e-06 | 3.2485e-06 | 4.816e-06 | 0.0 | 0.54 +Pair | 0.00034972 | 0.00037431 | 0.00039297 | 0.0 | 72.72 +Bond | 1.243e-06 | 2.7775e-06 | 4.618e-06 | 0.0 | 0.54 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 1.4157e-05 | 3.2696e-05 | 5.1431e-05 | 0.0 | 5.46 -Output | 0.00014589 | 0.0001627 | 0.00018978 | 0.0 | 27.19 -Modify | 1.649e-06 | 2.0097e-06 | 2.209e-06 | 0.0 | 0.34 -Other | | 1.205e-05 | | | 2.01 +Comm | 1.4468e-05 | 2.4821e-05 | 4.155e-05 | 0.0 | 4.82 +Output | 9.2384e-05 | 0.00010253 | 0.0001268 | 0.0 | 19.92 +Modify | 1.439e-06 | 1.7457e-06 | 2.12e-06 | 0.0 | 0.34 +Other | | 8.573e-06 | | | 1.67 Nlocal: 1.5 ave 3 max 0 min Histogram: 2 0 0 0 0 0 0 0 0 2 diff --git a/examples/amoeba/log.5Jul22.water_dimer.hippo.g++.1 b/examples/amoeba/log.5Jul22.water_dimer.hippo.g++.1 index dccb8dee21..137b6f4123 100644 --- a/examples/amoeba/log.5Jul22.water_dimer.hippo.g++.1 +++ b/examples/amoeba/log.5Jul22.water_dimer.hippo.g++.1 @@ -48,6 +48,7 @@ Finding 1-2 1-3 1-4 neighbors ... pair_style hippo pair_coeff * * hippo_water.prm hippo_water.key Reading potential file hippo_water.prm with DATE: 2022-07-05 +Reading potential file hippo_water.key with DATE: 2022-07-05 special_bonds lj/coul 0.5 0.5 0.5 one/five yes Finding 1-2 1-3 1-4 neighbors ... @@ -110,31 +111,31 @@ Per MPI rank memory allocation (min/avg/max) = 47.9 | 47.9 | 47.9 Mbytes 3 18.15288 -4.9496234 0.010334146 0.19125791 0 0 0.20159205 -4.47748 7115.3453 -5853.149 32274.916 -8557.0355 -41.982111 -17374.865 -42.455978 4 24.248994 -4.9153331 0.0093063079 0.065238074 0 0 0.074544382 -4.4793805 11356.801 5716.9586 25838.412 -2135.3667 -22.820662 -10495.224 -28.045156 5 26.136423 -4.8829114 0.0095061937 0.0039834608 0 0 0.013489654 -4.4798832 9044.3732 10498.874 11345.536 276.34491 -1.1467483 -1185.8556 -8.820154 -Loop time of 0.000210439 on 1 procs for 5 steps with 6 atoms +Loop time of 0.000212779 on 1 procs for 5 steps with 6 atoms -Performance: 2052.851 ns/day, 0.012 hours/ns, 23759.854 timesteps/s -98.4% CPU use with 1 MPI tasks x 1 OpenMP threads +Performance: 2030.276 ns/day, 0.012 hours/ns, 23498.560 timesteps/s +98.2% CPU use with 1 MPI tasks x 1 OpenMP threads HIPPO timing breakdown: - Init time: 5.006e-06 4.58% - Repulse time: 1.3587e-05 12.42% - Disp time: 5.471e-06 5.00% - Mpole time: 2.1321e-05 19.49% - Induce time: 3.7665e-05 34.43% - Polar time: 2.3919e-05 21.87% - Qxfer time: 2.295e-06 2.10% - Total time: 0.000109391 + Init time: 4.362e-06 3.79% + Repulse time: 1.3969e-05 12.14% + Disp time: 5.254e-06 4.57% + Mpole time: 2.6047e-05 22.64% + Induce time: 3.9053e-05 33.95% + Polar time: 2.3991e-05 20.86% + Qxfer time: 2.22e-06 1.93% + Total time: 0.000115031 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.00011125 | 0.00011125 | 0.00011125 | 0.0 | 52.86 -Bond | 3.062e-06 | 3.062e-06 | 3.062e-06 | 0.0 | 1.46 +Pair | 0.00011699 | 0.00011699 | 0.00011699 | 0.0 | 54.98 +Bond | 3.135e-06 | 3.135e-06 | 3.135e-06 | 0.0 | 1.47 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 6.3e-07 | 6.3e-07 | 6.3e-07 | 0.0 | 0.30 -Output | 8.8087e-05 | 8.8087e-05 | 8.8087e-05 | 0.0 | 41.86 -Modify | 1.664e-06 | 1.664e-06 | 1.664e-06 | 0.0 | 0.79 -Other | | 5.749e-06 | | | 2.73 +Comm | 5.59e-07 | 5.59e-07 | 5.59e-07 | 0.0 | 0.26 +Output | 8.5468e-05 | 8.5468e-05 | 8.5468e-05 | 0.0 | 40.17 +Modify | 1.509e-06 | 1.509e-06 | 1.509e-06 | 0.0 | 0.71 +Other | | 5.117e-06 | | | 2.40 Nlocal: 6 ave 6 max 6 min Histogram: 1 0 0 0 0 0 0 0 0 0 diff --git a/examples/amoeba/log.5Jul22.water_dimer.hippo.g++.4 b/examples/amoeba/log.5Jul22.water_dimer.hippo.g++.4 index 3758759b7a..0b1142db34 100644 --- a/examples/amoeba/log.5Jul22.water_dimer.hippo.g++.4 +++ b/examples/amoeba/log.5Jul22.water_dimer.hippo.g++.4 @@ -48,6 +48,7 @@ Finding 1-2 1-3 1-4 neighbors ... pair_style hippo pair_coeff * * hippo_water.prm hippo_water.key Reading potential file hippo_water.prm with DATE: 2022-07-05 +Reading potential file hippo_water.key with DATE: 2022-07-05 special_bonds lj/coul 0.5 0.5 0.5 one/five yes Finding 1-2 1-3 1-4 neighbors ... @@ -110,31 +111,31 @@ Per MPI rank memory allocation (min/avg/max) = 47.91 | 48.04 | 48.18 Mbytes 3 18.15288 -4.9496234 0.010334146 0.19125791 0 0 0.20159205 -4.47748 7115.3453 -5853.149 32274.916 -8557.0355 -41.982111 -17374.865 -42.455978 4 24.248994 -4.9153331 0.0093063079 0.065238074 0 0 0.074544382 -4.4793805 11356.801 5716.9586 25838.412 -2135.3667 -22.820662 -10495.224 -28.045156 5 26.136423 -4.8829114 0.0095061937 0.0039834608 0 0 0.013489654 -4.4798832 9044.3732 10498.874 11345.536 276.34491 -1.1467483 -1185.8556 -8.820154 -Loop time of 0.000488464 on 4 procs for 5 steps with 6 atoms +Loop time of 0.000517582 on 4 procs for 5 steps with 6 atoms -Performance: 884.405 ns/day, 0.027 hours/ns, 10236.169 timesteps/s -70.9% CPU use with 4 MPI tasks x 1 OpenMP threads +Performance: 834.650 ns/day, 0.029 hours/ns, 9660.305 timesteps/s +99.1% CPU use with 4 MPI tasks x 1 OpenMP threads HIPPO timing breakdown: - Init time: 1.2924e-05 4.50% - Repulse time: 2.01283e-05 7.01% - Disp time: 3.04475e-06 1.06% - Mpole time: 3.51807e-05 12.25% - Induce time: 0.000183034 63.71% - Polar time: 3.13832e-05 10.92% - Qxfer time: 1.44475e-06 0.50% - Total time: 0.000287298 + Init time: 1.2878e-05 4.19% + Repulse time: 1.95775e-05 6.37% + Disp time: 3.19075e-06 1.04% + Mpole time: 3.54465e-05 11.54% + Induce time: 0.000202696 65.99% + Polar time: 3.1646e-05 10.30% + Qxfer time: 1.54075e-06 0.50% + Total time: 0.000307141 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.00028193 | 0.00030553 | 0.00032173 | 0.0 | 62.55 -Bond | 1.317e-06 | 2.7712e-06 | 4.847e-06 | 0.0 | 0.57 +Pair | 0.00030206 | 0.00032867 | 0.00034858 | 0.0 | 63.50 +Bond | 1.25e-06 | 2.9003e-06 | 5.069e-06 | 0.0 | 0.56 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 1.3015e-05 | 3.0698e-05 | 4.1342e-05 | 0.0 | 6.28 -Output | 0.00012315 | 0.00013964 | 0.00015356 | 0.0 | 28.59 -Modify | 1.445e-06 | 1.881e-06 | 2.366e-06 | 0.0 | 0.39 -Other | | 7.949e-06 | | | 1.63 +Comm | 1.2972e-05 | 3.2595e-05 | 4.1932e-05 | 0.0 | 6.30 +Output | 0.00012571 | 0.00014253 | 0.000161 | 0.0 | 27.54 +Modify | 1.414e-06 | 2.006e-06 | 2.581e-06 | 0.0 | 0.39 +Other | | 8.876e-06 | | | 1.71 Nlocal: 1.5 ave 3 max 0 min Histogram: 2 0 0 0 0 0 0 0 0 2 diff --git a/examples/amoeba/log.5Jul22.water_hexamer.amoeba.g++.1 b/examples/amoeba/log.5Jul22.water_hexamer.amoeba.g++.1 index 03224a076e..210672e638 100644 --- a/examples/amoeba/log.5Jul22.water_hexamer.amoeba.g++.1 +++ b/examples/amoeba/log.5Jul22.water_hexamer.amoeba.g++.1 @@ -48,6 +48,7 @@ Finding 1-2 1-3 1-4 neighbors ... pair_style amoeba pair_coeff * * amoeba_water.prm amoeba_water.key Reading potential file amoeba_water.prm with DATE: 2022-07-05 +Reading potential file amoeba_water.key with DATE: 2022-07-05 special_bonds lj/coul 0.5 0.5 0.5 one/five yes Finding 1-2 1-3 1-4 neighbors ... @@ -107,29 +108,29 @@ Per MPI rank memory allocation (min/avg/max) = 48.28 | 48.28 | 48.28 Mbytes 3 15.996484 -46.59119 0.087228651 1.3862662 0 0 1.4734948 -44.307093 15705.166 28374.161 4124.662 13087.621 -6242.1769 3159.6508 1787.4159 4 10.888785 -45.839064 0.062461924 0.96598997 0 0 1.0284519 -44.258837 30226.38 48920.372 15666.108 25051.837 -9443.9251 2603.8275 435.5257 5 10.58575 -45.503287 0.071817565 0.64254674 0 0 0.71436431 -44.252503 31899.04 51066.283 18170.57 25448.409 -9478.6752 638.72265 -1011.7679 -Loop time of 0.00100127 on 1 procs for 5 steps with 18 atoms +Loop time of 0.00102528 on 1 procs for 5 steps with 18 atoms -Performance: 431.450 ns/day, 0.056 hours/ns, 4993.633 timesteps/s -99.8% CPU use with 1 MPI tasks x 1 OpenMP threads +Performance: 421.350 ns/day, 0.057 hours/ns, 4876.736 timesteps/s +97.8% CPU use with 1 MPI tasks x 1 OpenMP threads AMOEBA timing breakdown: - Init time: 1.2944e-05 1.45% - Hal time: 6.4578e-05 7.21% - Mpole time: 0.000124703 13.93% - Induce time: 0.000435232 48.60% - Polar time: 0.000257613 28.77% - Total time: 0.000895454 + Init time: 1.233e-05 1.38% + Hal time: 6.1298e-05 6.86% + Mpole time: 0.000124989 13.99% + Induce time: 0.000435176 48.70% + Polar time: 0.000259279 29.02% + Total time: 0.000893503 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.00089735 | 0.00089735 | 0.00089735 | 0.0 | 89.62 -Bond | 6.783e-06 | 6.783e-06 | 6.783e-06 | 0.0 | 0.68 +Pair | 0.0008955 | 0.0008955 | 0.0008955 | 0.0 | 87.34 +Bond | 6.723e-06 | 6.723e-06 | 6.723e-06 | 0.0 | 0.66 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 6.36e-07 | 6.36e-07 | 6.36e-07 | 0.0 | 0.06 -Output | 8.9119e-05 | 8.9119e-05 | 8.9119e-05 | 0.0 | 8.90 -Modify | 2.385e-06 | 2.385e-06 | 2.385e-06 | 0.0 | 0.24 -Other | | 4.998e-06 | | | 0.50 +Comm | 7.36e-07 | 7.36e-07 | 7.36e-07 | 0.0 | 0.07 +Output | 0.00011472 | 0.00011472 | 0.00011472 | 0.0 | 11.19 +Modify | 2.387e-06 | 2.387e-06 | 2.387e-06 | 0.0 | 0.23 +Other | | 5.206e-06 | | | 0.51 Nlocal: 18 ave 18 max 18 min Histogram: 1 0 0 0 0 0 0 0 0 0 diff --git a/examples/amoeba/log.5Jul22.water_hexamer.amoeba.g++.4 b/examples/amoeba/log.5Jul22.water_hexamer.amoeba.g++.4 index 1f5aff9134..d0813a0677 100644 --- a/examples/amoeba/log.5Jul22.water_hexamer.amoeba.g++.4 +++ b/examples/amoeba/log.5Jul22.water_hexamer.amoeba.g++.4 @@ -48,6 +48,7 @@ Finding 1-2 1-3 1-4 neighbors ... pair_style amoeba pair_coeff * * amoeba_water.prm amoeba_water.key Reading potential file amoeba_water.prm with DATE: 2022-07-05 +Reading potential file amoeba_water.key with DATE: 2022-07-05 special_bonds lj/coul 0.5 0.5 0.5 one/five yes Finding 1-2 1-3 1-4 neighbors ... @@ -108,29 +109,29 @@ Per MPI rank memory allocation (min/avg/max) = 48.3 | 48.3 | 48.3 Mbytes 3 15.996484 -46.59119 0.087228651 1.3862662 0 0 1.4734948 -44.307093 15705.166 28374.161 4124.662 13087.621 -6242.1769 3159.6508 1787.4159 4 10.888785 -45.839064 0.062461924 0.96598997 0 0 1.0284519 -44.258837 30226.38 48920.372 15666.108 25051.837 -9443.9251 2603.8275 435.5257 5 10.58575 -45.503287 0.071817565 0.64254674 0 0 0.71436431 -44.252503 31899.04 51066.283 18170.57 25448.409 -9478.6752 638.72265 -1011.7679 -Loop time of 0.00124102 on 4 procs for 5 steps with 18 atoms +Loop time of 0.00142392 on 4 procs for 5 steps with 18 atoms -Performance: 348.100 ns/day, 0.069 hours/ns, 4028.938 timesteps/s +Performance: 303.388 ns/day, 0.079 hours/ns, 3511.433 timesteps/s 99.4% CPU use with 4 MPI tasks x 1 OpenMP threads AMOEBA timing breakdown: - Init time: 1.93587e-05 1.89% - Hal time: 2.20198e-05 2.15% - Mpole time: 0.0001019 9.94% - Induce time: 0.000717017 69.95% - Polar time: 0.000164237 16.02% - Total time: 0.00102505 + Init time: 1.91963e-05 1.62% + Hal time: 2.47003e-05 2.08% + Mpole time: 0.000133592 11.24% + Induce time: 0.000773552 65.10% + Polar time: 0.000236616 19.91% + Total time: 0.00118822 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.0010331 | 0.0010362 | 0.0010375 | 0.0 | 83.50 -Bond | 3.723e-06 | 5.0355e-06 | 5.6e-06 | 0.0 | 0.41 +Pair | 0.0011966 | 0.0012002 | 0.0012035 | 0.0 | 84.29 +Bond | 3.666e-06 | 5.2103e-06 | 6.517e-06 | 0.0 | 0.37 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 1.7872e-05 | 4.1093e-05 | 6.4155e-05 | 0.0 | 3.31 -Output | 0.00012756 | 0.00014764 | 0.00016933 | 0.0 | 11.90 -Modify | 1.808e-06 | 2.4647e-06 | 2.74e-06 | 0.0 | 0.20 -Other | | 8.565e-06 | | | 0.69 +Comm | 1.5056e-05 | 5.6462e-05 | 7.9185e-05 | 0.0 | 3.97 +Output | 0.00012635 | 0.00014701 | 0.00018782 | 0.0 | 10.32 +Modify | 2.376e-06 | 2.7202e-06 | 3.086e-06 | 0.0 | 0.19 +Other | | 1.237e-05 | | | 0.87 Nlocal: 4.5 ave 6 max 3 min Histogram: 1 0 0 1 0 0 1 0 0 1 diff --git a/examples/amoeba/log.5Jul22.water_hexamer.hippo.g++.1 b/examples/amoeba/log.5Jul22.water_hexamer.hippo.g++.1 index e6a765c0e8..ab074128a4 100644 --- a/examples/amoeba/log.5Jul22.water_hexamer.hippo.g++.1 +++ b/examples/amoeba/log.5Jul22.water_hexamer.hippo.g++.1 @@ -48,6 +48,7 @@ Finding 1-2 1-3 1-4 neighbors ... pair_style hippo pair_coeff * * hippo_water.prm hippo_water.key Reading potential file hippo_water.prm with DATE: 2022-07-05 +Reading potential file hippo_water.key with DATE: 2022-07-05 special_bonds lj/coul 0.5 0.5 0.5 one/five yes Finding 1-2 1-3 1-4 neighbors ... @@ -109,31 +110,31 @@ Per MPI rank memory allocation (min/avg/max) = 47.84 | 47.84 | 47.84 Mbytes 3 19.013509 -45.750445 0.043880608 0.9336078 0 0 0.97748841 -43.809471 18351.549 29896.314 6275.5012 17065.39 -6055.8639 3664.6024 3015.6633 4 11.017518 -45.12347 0.24124811 0.58878104 0 0 0.83002915 -43.735142 35358.63 54252.632 19050.919 31719.21 -9822.7607 3160.7845 1520.1368 5 12.143149 -44.904245 0.22320916 0.3270434 0 0 0.55025256 -43.738653 35160.919 53395.572 20272.979 30653.482 -9511.0241 1392.4959 35.692826 -Loop time of 0.000984386 on 1 procs for 5 steps with 18 atoms +Loop time of 0.000973993 on 1 procs for 5 steps with 18 atoms -Performance: 438.852 ns/day, 0.055 hours/ns, 5079.308 timesteps/s -99.8% CPU use with 1 MPI tasks x 1 OpenMP threads +Performance: 443.535 ns/day, 0.054 hours/ns, 5133.507 timesteps/s +99.7% CPU use with 1 MPI tasks x 1 OpenMP threads HIPPO timing breakdown: - Init time: 1.2669e-05 1.45% - Repulse time: 0.000132325 15.15% - Disp time: 4.2534e-05 4.87% - Mpole time: 0.000177341 20.30% - Induce time: 0.000303723 34.77% - Polar time: 0.000179318 20.53% - Qxfer time: 2.5413e-05 2.91% - Total time: 0.000873466 + Init time: 1.2301e-05 1.42% + Repulse time: 0.000131627 15.20% + Disp time: 4.2386e-05 4.89% + Mpole time: 0.000181895 21.00% + Induce time: 0.000295778 34.15% + Polar time: 0.000178781 20.64% + Qxfer time: 2.3214e-05 2.68% + Total time: 0.00086611 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.00087559 | 0.00087559 | 0.00087559 | 0.0 | 88.95 -Bond | 6.455e-06 | 6.455e-06 | 6.455e-06 | 0.0 | 0.66 +Pair | 0.0008683 | 0.0008683 | 0.0008683 | 0.0 | 89.15 +Bond | 5.954e-06 | 5.954e-06 | 5.954e-06 | 0.0 | 0.61 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 7.87e-07 | 7.87e-07 | 7.87e-07 | 0.0 | 0.08 -Output | 9.3142e-05 | 9.3142e-05 | 9.3142e-05 | 0.0 | 9.46 -Modify | 2.351e-06 | 2.351e-06 | 2.351e-06 | 0.0 | 0.24 -Other | | 6.065e-06 | | | 0.62 +Comm | 6.69e-07 | 6.69e-07 | 6.69e-07 | 0.0 | 0.07 +Output | 9.1764e-05 | 9.1764e-05 | 9.1764e-05 | 0.0 | 9.42 +Modify | 2.34e-06 | 2.34e-06 | 2.34e-06 | 0.0 | 0.24 +Other | | 4.965e-06 | | | 0.51 Nlocal: 18 ave 18 max 18 min Histogram: 1 0 0 0 0 0 0 0 0 0 diff --git a/examples/amoeba/log.5Jul22.water_hexamer.hippo.g++.4 b/examples/amoeba/log.5Jul22.water_hexamer.hippo.g++.4 index 02d9b0f6f2..cea8fe5b53 100644 --- a/examples/amoeba/log.5Jul22.water_hexamer.hippo.g++.4 +++ b/examples/amoeba/log.5Jul22.water_hexamer.hippo.g++.4 @@ -48,6 +48,7 @@ Finding 1-2 1-3 1-4 neighbors ... pair_style hippo pair_coeff * * hippo_water.prm hippo_water.key Reading potential file hippo_water.prm with DATE: 2022-07-05 +Reading potential file hippo_water.key with DATE: 2022-07-05 special_bonds lj/coul 0.5 0.5 0.5 one/five yes Finding 1-2 1-3 1-4 neighbors ... @@ -110,31 +111,31 @@ Per MPI rank memory allocation (min/avg/max) = 47.86 | 47.86 | 47.86 Mbytes 3 19.013509 -45.750445 0.043880608 0.9336078 0 0 0.97748841 -43.809471 18351.549 29896.314 6275.5012 17065.39 -6055.8639 3664.6024 3015.6633 4 11.017518 -45.12347 0.24124811 0.58878104 0 0 0.83002915 -43.735142 35358.63 54252.632 19050.919 31719.21 -9822.7607 3160.7845 1520.1368 5 12.143149 -44.904245 0.22320916 0.3270434 0 0 0.55025256 -43.738653 35160.919 53395.572 20272.979 30653.482 -9511.0241 1392.4959 35.692826 -Loop time of 0.00126451 on 4 procs for 5 steps with 18 atoms +Loop time of 0.0010879 on 4 procs for 5 steps with 18 atoms -Performance: 341.634 ns/day, 0.070 hours/ns, 3954.096 timesteps/s -92.2% CPU use with 4 MPI tasks x 1 OpenMP threads +Performance: 397.096 ns/day, 0.060 hours/ns, 4596.020 timesteps/s +97.6% CPU use with 4 MPI tasks x 1 OpenMP threads HIPPO timing breakdown: - Init time: 1.75712e-05 1.72% - Repulse time: 0.000116156 11.39% - Disp time: 1.69788e-05 1.66% - Mpole time: 0.000178714 17.52% - Induce time: 0.000515806 50.57% - Polar time: 0.0001659 16.27% - Qxfer time: 8.64975e-06 0.85% - Total time: 0.00101993 + Init time: 1.85215e-05 2.13% + Repulse time: 9.38538e-05 10.79% + Disp time: 1.49635e-05 1.72% + Mpole time: 0.000126348 14.53% + Induce time: 0.000481476 55.36% + Polar time: 0.000126323 14.53% + Qxfer time: 8.01125e-06 0.92% + Total time: 0.000869664 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.0010223 | 0.0010316 | 0.001045 | 0.0 | 81.58 -Bond | 3.062e-06 | 4.3805e-06 | 5.123e-06 | 0.0 | 0.35 +Pair | 0.00087311 | 0.00088213 | 0.00088962 | 0.0 | 81.09 +Bond | 3.358e-06 | 4.3378e-06 | 4.915e-06 | 0.0 | 0.40 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 1.4853e-05 | 6.5245e-05 | 9.2753e-05 | 0.0 | 5.16 -Output | 0.0001294 | 0.00014959 | 0.00018927 | 0.0 | 11.83 -Modify | 1.595e-06 | 2.2495e-06 | 2.798e-06 | 0.0 | 0.18 -Other | | 1.145e-05 | | | 0.91 +Comm | 2.4495e-05 | 4.3727e-05 | 6.9446e-05 | 0.0 | 4.02 +Output | 0.00012885 | 0.00014625 | 0.00016056 | 0.0 | 13.44 +Modify | 2.162e-06 | 2.5343e-06 | 2.766e-06 | 0.0 | 0.23 +Other | | 8.911e-06 | | | 0.82 Nlocal: 4.5 ave 6 max 3 min Histogram: 1 0 0 1 0 0 1 0 0 1 From 1599afc623bf6083e9d5bac6c7be10de21b07879 Mon Sep 17 00:00:00 2001 From: Jacob Gissinger Date: Wed, 6 Jul 2022 00:45:36 -0400 Subject: [PATCH 535/585] clarify how reaxff/species decides when to reneighbor --- doc/src/fix_reaxff_species.rst | 19 ++++++++++++------- 1 file changed, 12 insertions(+), 7 deletions(-) diff --git a/doc/src/fix_reaxff_species.rst b/doc/src/fix_reaxff_species.rst index 208ee31009..11f0e7b7e7 100644 --- a/doc/src/fix_reaxff_species.rst +++ b/doc/src/fix_reaxff_species.rst @@ -68,13 +68,18 @@ the first line. .. warning:: In order to compute averaged data, it is required that there are no - neighbor list rebuilds between the *Nfreq* steps. For that reason, fix - *reaxff/species* may change your neighbor list settings. There will - be a warning message showing the new settings. Having an *Nfreq* - setting that is larger than what is required for correct computation - of the ReaxFF force field interactions can thus lead to incorrect - results. For typical ReaxFF calculations a value of 100 is already - quite large. + neighbor list rebuilds for at least Nrepeat\*Nevery steps preceding + each *Nfreq* step. For that reason, fix *reaxff/species* may + change your neighbor list settings. Reneighboring will occur no + more frequently than every Nrepeat\*Nevery timesteps, and will + occur less frequently if *Nfreq* is not a multiple of + Nrepeat\*Nevery. There will be a warning message showing the new + settings. Having a *Nfreq* setting that is larger than what is + required for correct computation of the ReaxFF force field + interactions, in combination with certain *Nrepeat* and *Nevery* + settings, can thus lead to incorrect results. For typical ReaxFF + calculations, reneighboring only every 100 steps is already quite a + low frequency. If the filename ends with ".gz", the output file is written in gzipped format. A gzipped dump file will be about 3x smaller than the text version, From 14299b36ba3b5a1bc390c913b9c24277cb9718b8 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 7 Jul 2022 08:59:08 -0400 Subject: [PATCH 536/585] correct force and energy for excluded pairs --- src/EXTRA-PAIR/pair_coul_slater_long.cpp | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/src/EXTRA-PAIR/pair_coul_slater_long.cpp b/src/EXTRA-PAIR/pair_coul_slater_long.cpp index 65619f0f65..7351c2a493 100644 --- a/src/EXTRA-PAIR/pair_coul_slater_long.cpp +++ b/src/EXTRA-PAIR/pair_coul_slater_long.cpp @@ -124,7 +124,7 @@ void PairCoulSlaterLong::compute(int eflag, int vflag) slater_term = exp(-2*r/lamda)*(1 + (2*r/lamda*(1+r/lamda))); prefactor = qqrd2e * scale[itype][jtype] * qtmp*q[j]/r; forcecoul = prefactor * (erfc + EWALD_F*grij*expm2 - slater_term); - if (factor_coul < 1.0) forcecoul -= (1.0-factor_coul)*prefactor; + if (factor_coul < 1.0) forcecoul -= (1.0-factor_coul)*prefactor*(1-slater_term); fpair = forcecoul * r2inv; @@ -139,7 +139,7 @@ void PairCoulSlaterLong::compute(int eflag, int vflag) if (eflag) { ecoul = prefactor*(erfc - (1 + r/lamda)*exp(-2*r/lamda)); - if (factor_coul < 1.0) ecoul -= (1.0-factor_coul)*prefactor; + if (factor_coul < 1.0) ecoul -= (1.0-factor_coul)*prefactor*(1.0-(1 + r/lamda)*exp(-2*r/lamda)); } if (evflag) ev_tally(i,j,nlocal,newton_pair, From fc508bc7b1b244689d72108808663491d00e6353 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 7 Jul 2022 08:59:49 -0400 Subject: [PATCH 537/585] apply clang-format --- src/EXTRA-PAIR/pair_coul_slater_long.cpp | 18 +++++++++--------- 1 file changed, 9 insertions(+), 9 deletions(-) diff --git a/src/EXTRA-PAIR/pair_coul_slater_long.cpp b/src/EXTRA-PAIR/pair_coul_slater_long.cpp index 7351c2a493..6662ae3721 100644 --- a/src/EXTRA-PAIR/pair_coul_slater_long.cpp +++ b/src/EXTRA-PAIR/pair_coul_slater_long.cpp @@ -116,14 +116,14 @@ void PairCoulSlaterLong::compute(int eflag, int vflag) if (rsq < cut_coulsq) { r2inv = 1.0/rsq; - r = sqrt(rsq); - grij = g_ewald * r; - expm2 = exp(-grij*grij); - t = 1.0 / (1.0 + EWALD_P*grij); - erfc = t * (A1+t*(A2+t*(A3+t*(A4+t*A5)))) * expm2; - slater_term = exp(-2*r/lamda)*(1 + (2*r/lamda*(1+r/lamda))); - prefactor = qqrd2e * scale[itype][jtype] * qtmp*q[j]/r; - forcecoul = prefactor * (erfc + EWALD_F*grij*expm2 - slater_term); + r = sqrt(rsq); + grij = g_ewald * r; + expm2 = exp(-grij*grij); + t = 1.0 / (1.0 + EWALD_P*grij); + erfc = t * (A1+t*(A2+t*(A3+t*(A4+t*A5)))) * expm2; + slater_term = exp(-2*r/lamda)*(1 + (2*r/lamda*(1+r/lamda))); + prefactor = qqrd2e * scale[itype][jtype] * qtmp*q[j]/r; + forcecoul = prefactor * (erfc + EWALD_F*grij*expm2 - slater_term); if (factor_coul < 1.0) forcecoul -= (1.0-factor_coul)*prefactor*(1-slater_term); fpair = forcecoul * r2inv; @@ -138,7 +138,7 @@ void PairCoulSlaterLong::compute(int eflag, int vflag) } if (eflag) { - ecoul = prefactor*(erfc - (1 + r/lamda)*exp(-2*r/lamda)); + ecoul = prefactor*(erfc - (1 + r/lamda)*exp(-2*r/lamda)); if (factor_coul < 1.0) ecoul -= (1.0-factor_coul)*prefactor*(1.0-(1 + r/lamda)*exp(-2*r/lamda)); } From 66c1d8bbca60809c452714dc13d5726cd1c33118 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 7 Jul 2022 09:01:16 -0400 Subject: [PATCH 538/585] update unit test --- .../tests/mol-pair-coul_slater_long.yaml | 128 +++++++++--------- 1 file changed, 64 insertions(+), 64 deletions(-) diff --git a/unittest/force-styles/tests/mol-pair-coul_slater_long.yaml b/unittest/force-styles/tests/mol-pair-coul_slater_long.yaml index becaaddacb..52efdaa52d 100644 --- a/unittest/force-styles/tests/mol-pair-coul_slater_long.yaml +++ b/unittest/force-styles/tests/mol-pair-coul_slater_long.yaml @@ -1,6 +1,6 @@ --- -lammps_version: 17 Feb 2022 -date_generated: Fri Mar 18 22:17:29 2022 +lammps_version: 23 Jun 2022 +date_generated: Thu Jul 7 09:00:39 2022 epsilon: 2e-13 skip_tests: prerequisites: ! | @@ -21,71 +21,71 @@ extract: ! | cut_coul 0 natoms: 29 init_vdwl: 0 -init_coul: 531.6959978948178 +init_coul: 254.5592842067175 init_stress: ! |2- - 2.5972486027624825e+02 1.6017698793801901e+02 2.4137753464923463e+02 1.1278136362375312e+02 7.5965726957592040e+01 4.3719482306226765e-01 + 1.1708139667614163e-01 -2.1626456898855512e+01 -1.2229635861086752e+01 1.1761975361937868e+01 -9.4490379133316071e-01 7.0303045871968024e+00 init_forces: ! |2 - 1 -1.4505459775863072e+01 -1.3044138972612792e+01 2.1164399702389403e+01 - 2 1.7223357637414050e+01 1.1196601670721074e+01 -2.1963333681835362e+01 - 3 1.9690750992824077e-01 8.4027350365370912e-01 3.2676598741321244e-01 - 4 -4.1823205578686712e-01 -4.8034612329946474e-01 -6.2465767147804363e-01 - 5 -8.1067146840659532e-01 -7.0419963313519196e-01 1.0662874339675656e-01 - 6 -1.5369327833513578e+01 1.5524058497083976e+01 2.0805079862911210e+01 - 7 2.5724194203247794e+00 -6.5060840392199450e+00 -2.5818209750744270e+01 - 8 5.4989014023099685e+00 -1.3233615378795388e+01 -1.9749310147567481e+01 - 9 6.7810825735410649e+00 2.9735670644350400e+00 2.9299979326310858e+01 - 10 1.5690354534134865e+00 -3.8317369465722124e+00 -4.6200627486826261e-02 - 11 -3.3949224827476737e-01 6.3351363413160511e-01 4.2844876717729496e-01 - 12 3.5635170964422114e-01 -1.4508136789019890e+00 3.4423369459456787e+00 - 13 3.1047049296276570e+00 -1.3699917700047379e+00 -1.9294387191193760e-01 - 14 -1.8808718796901713e+00 4.5935276633752392e-01 -3.4319894559470154e+00 - 15 5.0373263520628020e-01 3.2293151135885791e+00 1.4501551118828643e-01 - 16 9.3153064058538995e+00 -7.2444035690649828e+00 -2.8031955215690214e+01 - 17 -1.2854116750038774e+01 1.2711581809604329e+01 2.2641980278104416e+01 - 18 -4.3096955761758995e+00 -1.9223912022853014e+01 7.9000623254438963e+01 - 19 -3.6557250488749723e+01 -2.4008797712603496e+01 -4.6906379653253587e+01 - 20 4.0430244682537058e+01 4.3367408075615103e+01 -3.0568173216213165e+01 - 21 -2.2233648415360879e+01 -2.5175462230434459e+01 7.7556799814543822e+01 - 22 -3.2896290497889161e+01 -7.4008238647922955e+00 -5.6779521143055455e+01 - 23 5.4738206511131686e+01 3.2962897136082404e+01 -2.0302232663948129e+01 - 24 1.6836507718223405e+01 -6.8988891903011790e+01 4.0189734824880482e+01 - 25 -4.9788824311046007e+01 1.0298368296372720e+01 -4.2822722831087503e+01 - 26 3.2480024672491567e+01 5.8484108401966807e+01 2.1410689331760921e+00 - 27 1.0631780570743651e+01 -7.5812252190257794e+01 2.6785237094554518e+01 - 28 -5.1807337133621779e+01 2.4969152478376095e+01 -3.5819948334944876e+01 - 29 4.1532654602026298e+01 5.0825271587590592e+01 9.0234792187328665e+00 + 1 1.0123638170253564e+00 -1.2509301778440569e+00 2.1945424754579066e+00 + 2 1.2954585046924219e+00 -1.6338868361150480e+00 -3.0887376983421388e+00 + 3 2.5466335168114949e-02 -1.3139527326988556e-02 3.5569205669245270e-02 + 4 -1.2001437337468715e-01 -5.6411226640158199e-02 -2.7885583471425601e-01 + 5 -5.1442751513887475e-01 3.3619784208637826e-01 -5.8612509036156044e-02 + 6 2.0722678070474260e-01 -2.0158659756241346e+00 1.2290591371946380e-01 + 7 1.2567425258842402e-01 1.6224546679223717e-01 1.2761543372504829e+00 + 8 -1.0885715086892622e+00 2.7631213623524755e+00 -1.1767360015218493e-01 + 9 1.4894653246735305e+00 -3.7617960133817596e+00 3.1053923325311867e+00 + 10 -7.1355785210118067e-02 3.1060808027765684e-02 -1.9612261171752393e-01 + 11 -6.7234571380736030e-01 7.7973238090172237e-01 -4.0949779264856478e-01 + 12 2.3138844234286426e+00 -4.3745924070374187e-01 1.4448078371866295e+00 + 13 1.4660368459556450e-01 -1.5128217536790745e-01 -1.4303100577311031e-01 + 14 -8.0170764963523022e-01 2.5412749138723761e-01 -3.4566627523769955e-01 + 15 3.3139749151276299e-01 7.0760705097098225e-02 -7.8854914191841807e-01 + 16 1.6259331841614227e-01 -9.7505266997933193e-01 -1.0324909305416741e+00 + 17 -2.8980837212603436e+00 5.6015117342873459e+00 -3.2180999995572175e+00 + 18 -1.9982604761757349e-02 2.3277591984645070e+00 5.7125759352746586e-01 + 19 -9.3976757841446423e-01 -2.1798221084742129e+00 4.9912918497113157e-01 + 20 5.2304880078763782e-01 -1.3238749831696685e-02 4.5568360647359851e-01 + 21 -4.8423714829029962e-01 1.3829719239752545e+00 -2.9605371449607998e-01 + 22 -5.7875171427304151e-01 -7.4682110680773817e-01 1.1868729457280150e-01 + 23 6.7125646044497977e-01 -2.4953977631185778e-01 6.5241242746355066e-01 + 24 2.4761790219940844e-01 1.3513641756258139e+00 -5.1709840925954764e-01 + 25 -1.1849995949271324e+00 -1.0312698215846192e+00 -5.7625135838985497e-01 + 26 4.6508977239668642e-01 -5.2650955871347083e-01 6.0143069461846999e-01 + 27 -7.4501807019330935e-01 1.4539167477546999e+00 -6.3344271356143678e-01 + 28 -2.3479546881246116e-01 -1.0024440823389091e+00 1.1214449785783520e-01 + 29 1.3369115781539251e+00 -4.6930078970690337e-01 5.1006619404609643e-01 run_vdwl: 0 -run_coul: 531.6316938435255 +run_coul: 254.55391272325517 run_stress: ! |2- - 2.6009236274938775e+02 1.6019149935649892e+02 2.4091972549720990e+02 1.1287278205291214e+02 7.6421249875941328e+01 1.0477154416076908e+00 + 1.0507664945308685e-01 -2.1621055562665443e+01 -1.2221091005466242e+01 1.1755690602099170e+01 -9.5887133975896877e-01 7.0291169104254232e+00 run_forces: ! |2 - 1 -1.4505263340624662e+01 -1.3069826884538898e+01 2.1092273240232334e+01 - 2 1.7216929699569594e+01 1.1222653354918181e+01 -2.1892026658892760e+01 - 3 1.9689659133582163e-01 8.4089709839905469e-01 3.2691229507601138e-01 - 4 -4.1534123724459276e-01 -4.7942040205303499e-01 -6.2372283685814967e-01 - 5 -8.0983629907930077e-01 -7.0364522896705939e-01 1.0613059784230094e-01 - 6 -1.5349604856791370e+01 1.5522546924799940e+01 2.0756281297832874e+01 - 7 2.5720205395173057e+00 -6.5136694191526150e+00 -2.5754699982146299e+01 - 8 5.4783011177980798e+00 -1.3193790377127209e+01 -1.9732158944509290e+01 - 9 6.7823956616450456e+00 2.9328643102381267e+00 2.9267293877977238e+01 - 10 1.5701490834675309e+00 -3.8293776378819531e+00 -4.4681502716367193e-02 - 11 -3.4080685500280089e-01 6.3394138301719993e-01 4.2521300521638838e-01 - 12 3.6335920149821210e-01 -1.4542882227067147e+00 3.4250588402471536e+00 - 13 3.1021896119350991e+00 -1.3629775427304498e+00 -1.9236601260012270e-01 - 14 -1.8791529231416744e+00 4.5416896729772194e-01 -3.4214086468019449e+00 - 15 4.9947705909602841e-01 3.2294681516348525e+00 1.5065456540899641e-01 - 16 9.3152895494380115e+00 -7.2584606007912740e+00 -2.8037105174417249e+01 - 17 -1.2853807315028448e+01 1.2730457404190695e+01 2.2646649542757135e+01 - 18 -3.8896274444740597e+00 -1.8742984005196448e+01 7.8575622292818892e+01 - 19 -3.6657681210304887e+01 -2.4147367233205287e+01 -4.6880920994817359e+01 - 20 4.0110836482195197e+01 4.3026017430590635e+01 -3.0166674909873894e+01 - 21 -2.2266717418800365e+01 -2.5007792207614962e+01 7.7439548112199361e+01 - 22 -3.2986424583514150e+01 -7.4943575521934962e+00 -5.6719145374965272e+01 - 23 5.4861504180702049e+01 3.2888028352139067e+01 -2.0245497429195499e+01 - 24 1.6994333620812245e+01 -6.9071608975734406e+01 4.0281992417369800e+01 - 25 -5.0022578934028282e+01 1.0236526699813956e+01 -4.3029340089682030e+01 - 26 3.2556772729625038e+01 5.8630191330865074e+01 2.2575959885742858e+00 - 27 1.0740675179027832e+01 -7.5810812405906574e+01 2.6655288241835144e+01 - 28 -5.1859214575097845e+01 2.4967730720910470e+01 -3.5779461664571272e+01 - 29 4.1474926685469335e+01 5.0824886566985427e+01 9.1126959066595141e+00 + 1 1.0112873572811580e+00 -1.2530276549384933e+00 2.1914171798830568e+00 + 2 1.2910756618724584e+00 -1.6320587244040410e+00 -3.0856670933130275e+00 + 3 2.5417581409305202e-02 -1.3319027044403169e-02 3.5458204071365587e-02 + 4 -1.1903572341057568e-01 -5.6295979790903755e-02 -2.7900490837896463e-01 + 5 -5.1384628561765300e-01 3.3652540945011555e-01 -5.8862099577371089e-02 + 6 2.0557510022365150e-01 -2.0123835505068053e+00 1.2614266602622692e-01 + 7 1.2735793319460478e-01 1.5853467760283904e-01 1.2701822406914272e+00 + 8 -1.0845932144371644e+00 2.7620784785572590e+00 -1.1812899137169540e-01 + 9 1.4885988571079642e+00 -3.7664983214134815e+00 3.1092838634072559e+00 + 10 -7.1576372143287825e-02 3.0962708284801813e-02 -1.9638669006856277e-01 + 11 -6.7233593581762241e-01 7.8020791757188945e-01 -4.0861239677017752e-01 + 12 2.3142942085570231e+00 -4.3672211901097824e-01 1.4445175637184764e+00 + 13 1.4585640919457624e-01 -1.5151491185814414e-01 -1.4301903387021225e-01 + 14 -8.0211823601348731e-01 2.5440367515238671e-01 -3.4418722798600709e-01 + 15 3.3243392757719303e-01 6.9345316666666712e-02 -7.8979319762464939e-01 + 16 1.6228153766652689e-01 -9.7649864654379481e-01 -1.0325498581820041e+00 + 17 -2.8985741606086464e+00 5.6081200657787251e+00 -3.2210360520327095e+00 + 18 -2.4779821561789064e-02 2.3252812699411116e+00 5.7548476355559375e-01 + 19 -9.3073282073812136e-01 -2.1761428427184564e+00 5.0466585562048227e-01 + 20 5.1962859124254412e-01 -1.3823144408831962e-02 4.4616022167444958e-01 + 21 -4.8279265992792930e-01 1.3791791897341579e+00 -2.9615403241565003e-01 + 22 -5.7432971719583037e-01 -7.4279690320955927e-01 1.2017370691438947e-01 + 23 6.6583750391632179e-01 -2.5085912738116967e-01 6.5043205083268785e-01 + 24 2.4365888962669718e-01 1.3544800679852296e+00 -5.2159886075913586e-01 + 25 -1.1794061912936245e+00 -1.0316188106119735e+00 -5.6975657126355306e-01 + 26 4.6484502577860515e-01 -5.2739147192840230e-01 6.0227258976224862e-01 + 27 -7.4688344945317542e-01 1.4562803511493001e+00 -6.3143583726328756e-01 + 28 -2.3319583763082030e-01 -1.0037908986220945e+00 1.1105104982326264e-01 + 29 1.3360518412010989e+00 -4.7065699348295009e-01 5.0895089489608403e-01 ... From 0bae7108b503bf194fdabea13a9c57da78a8a92c Mon Sep 17 00:00:00 2001 From: rohskopf Date: Thu, 7 Jul 2022 11:09:10 -0600 Subject: [PATCH 539/585] Whitespace and format --- lammps | 1 + src/ML-SNAP/compute_snap.cpp | 144 ++++++++++++++++++----------------- src/ML-SNAP/compute_snap.h | 1 - 3 files changed, 75 insertions(+), 71 deletions(-) create mode 120000 lammps diff --git a/lammps b/lammps new file mode 120000 index 0000000000..6ce10c039d --- /dev/null +++ b/lammps @@ -0,0 +1 @@ +python/lammps/ \ No newline at end of file diff --git a/src/ML-SNAP/compute_snap.cpp b/src/ML-SNAP/compute_snap.cpp index 5b935320ee..dca3fd3c01 100644 --- a/src/ML-SNAP/compute_snap.cpp +++ b/src/ML-SNAP/compute_snap.cpp @@ -24,7 +24,6 @@ #include "comm.h" #include "memory.h" #include "error.h" -#include "universe.h" // For MPI #include @@ -268,9 +267,9 @@ void ComputeSnap::init() // allocate memory for global array memory->create(snap,size_array_rows,size_array_cols, - "snap:snap"); + "snap:snap"); memory->create(snapall,size_array_rows,size_array_cols, - "snap:snapall"); + "snap:snapall"); array = snapall; // find compute for reference energy @@ -321,6 +320,7 @@ void ComputeSnap::compute_array() } // clear global array + for (int irow = 0; irow < size_array_rows; irow++){ for (int icoeff = 0; icoeff < size_array_cols; icoeff++){ snap[irow][icoeff] = 0.0; @@ -371,7 +371,9 @@ void ComputeSnap::compute_array() const int typeoffset_global = nvalues*(itype-1); if (dgradflag){ + // dBi/dRi tags + snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 0][0] = atom->tag[i]-1; snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 0][1] = atom->tag[i]-1; snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 0][2] = 0; @@ -381,7 +383,9 @@ void ComputeSnap::compute_array() snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 2][0] = atom->tag[i]-1; snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 2][1] = atom->tag[i]-1; snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 2][2] = 2; + // dBi/dRj tags + for (int j=0; jtag[i]-1) + 0][0] = atom->tag[i]-1; snap[bik_rows + ((j)*3*natoms) + 3*(atom->tag[i]-1) + 0][1] = j; @@ -451,72 +455,72 @@ void ComputeSnap::compute_array() // accumulate dBi/dRi, -dBi/dRj - if (!dgradflag) { + if (!dgradflag) { - double *snadi = snap_peratom[i]+typeoffset_local; - double *snadj = snap_peratom[j]+typeoffset_local; + double *snadi = snap_peratom[i]+typeoffset_local; + double *snadj = snap_peratom[j]+typeoffset_local; - for (int icoeff = 0; icoeff < ncoeff; icoeff++) { + for (int icoeff = 0; icoeff < ncoeff; icoeff++) { - snadi[icoeff] += snaptr->dblist[icoeff][0]; - snadi[icoeff+yoffset] += snaptr->dblist[icoeff][1]; - snadi[icoeff+zoffset] += snaptr->dblist[icoeff][2]; + snadi[icoeff] += snaptr->dblist[icoeff][0]; + snadi[icoeff+yoffset] += snaptr->dblist[icoeff][1]; + snadi[icoeff+zoffset] += snaptr->dblist[icoeff][2]; - snadj[icoeff] -= snaptr->dblist[icoeff][0]; - snadj[icoeff+yoffset] -= snaptr->dblist[icoeff][1]; - snadj[icoeff+zoffset] -= snaptr->dblist[icoeff][2]; - } + snadj[icoeff] -= snaptr->dblist[icoeff][0]; + snadj[icoeff+yoffset] -= snaptr->dblist[icoeff][1]; + snadj[icoeff+zoffset] -= snaptr->dblist[icoeff][2]; + } - if (quadraticflag) { - const int quadraticoffset = ncoeff; - snadi += quadraticoffset; - snadj += quadraticoffset; - int ncount = 0; - for (int icoeff = 0; icoeff < ncoeff; icoeff++) { - double bi = snaptr->blist[icoeff]; - double bix = snaptr->dblist[icoeff][0]; - double biy = snaptr->dblist[icoeff][1]; - double biz = snaptr->dblist[icoeff][2]; + if (quadraticflag) { + const int quadraticoffset = ncoeff; + snadi += quadraticoffset; + snadj += quadraticoffset; + int ncount = 0; + for (int icoeff = 0; icoeff < ncoeff; icoeff++) { + double bi = snaptr->blist[icoeff]; + double bix = snaptr->dblist[icoeff][0]; + double biy = snaptr->dblist[icoeff][1]; + double biz = snaptr->dblist[icoeff][2]; - // diagonal elements of quadratic matrix + // diagonal elements of quadratic matrix - double dbxtmp = bi*bix; - double dbytmp = bi*biy; - double dbztmp = bi*biz; + double dbxtmp = bi*bix; + double dbytmp = bi*biy; + double dbztmp = bi*biz; - snadi[ncount] += dbxtmp; - snadi[ncount+yoffset] += dbytmp; - snadi[ncount+zoffset] += dbztmp; - snadj[ncount] -= dbxtmp; - snadj[ncount+yoffset] -= dbytmp; - snadj[ncount+zoffset] -= dbztmp; + snadi[ncount] += dbxtmp; + snadi[ncount+yoffset] += dbytmp; + snadi[ncount+zoffset] += dbztmp; + snadj[ncount] -= dbxtmp; + snadj[ncount+yoffset] -= dbytmp; + snadj[ncount+zoffset] -= dbztmp; - ncount++; + ncount++; - // upper-triangular elements of quadratic matrix + // upper-triangular elements of quadratic matrix - for (int jcoeff = icoeff+1; jcoeff < ncoeff; jcoeff++) { - double dbxtmp = bi*snaptr->dblist[jcoeff][0] - + bix*snaptr->blist[jcoeff]; - double dbytmp = bi*snaptr->dblist[jcoeff][1] - + biy*snaptr->blist[jcoeff]; - double dbztmp = bi*snaptr->dblist[jcoeff][2] - + biz*snaptr->blist[jcoeff]; + for (int jcoeff = icoeff+1; jcoeff < ncoeff; jcoeff++) { + double dbxtmp = bi*snaptr->dblist[jcoeff][0] + + bix*snaptr->blist[jcoeff]; + double dbytmp = bi*snaptr->dblist[jcoeff][1] + + biy*snaptr->blist[jcoeff]; + double dbztmp = bi*snaptr->dblist[jcoeff][2] + + biz*snaptr->blist[jcoeff]; - snadi[ncount] += dbxtmp; - snadi[ncount+yoffset] += dbytmp; - snadi[ncount+zoffset] += dbztmp; - snadj[ncount] -= dbxtmp; - snadj[ncount+yoffset] -= dbytmp; - snadj[ncount+zoffset] -= dbztmp; + snadi[ncount] += dbxtmp; + snadi[ncount+yoffset] += dbytmp; + snadi[ncount+zoffset] += dbztmp; + snadj[ncount] -= dbxtmp; + snadj[ncount+yoffset] -= dbytmp; + snadj[ncount+zoffset] -= dbztmp; - ncount++; - } - } - } - } else { + ncount++; + } + } + } + } else { - for (int icoeff = 0; icoeff < ncoeff; icoeff++) { + for (int icoeff = 0; icoeff < ncoeff; icoeff++) { // add to snap array for this proc @@ -531,9 +535,9 @@ void ComputeSnap::compute_array() snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 0][icoeff+3] += snaptr->dblist[icoeff][0]; snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 1][icoeff+3] += snaptr->dblist[icoeff][1]; snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 2][icoeff+3] += snaptr->dblist[icoeff][2]; - } + } - } + } } // loop over jj inside @@ -541,30 +545,30 @@ void ComputeSnap::compute_array() if (!dgradflag) { - // linear contributions + // linear contributions int k = typeoffset_global; for (int icoeff = 0; icoeff < ncoeff; icoeff++) snap[irow][k++] += snaptr->blist[icoeff]; - // quadratic contributions + // quadratic contributions - if (quadraticflag) { - for (int icoeff = 0; icoeff < ncoeff; icoeff++) { - double bveci = snaptr->blist[icoeff]; - snap[irow][k++] += 0.5*bveci*bveci; - for (int jcoeff = icoeff+1; jcoeff < ncoeff; jcoeff++) { - double bvecj = snaptr->blist[jcoeff]; - snap[irow][k++] += bveci*bvecj; - } - } - } + if (quadraticflag) { + for (int icoeff = 0; icoeff < ncoeff; icoeff++) { + double bveci = snaptr->blist[icoeff]; + snap[irow][k++] += 0.5*bveci*bveci; + for (int jcoeff = icoeff+1; jcoeff < ncoeff; jcoeff++) { + double bvecj = snaptr->blist[jcoeff]; + snap[irow][k++] += bveci*bvecj; + } + } + } } else { int k = 3; for (int icoeff = 0; icoeff < ncoeff; icoeff++) snap[irow][k++] += snaptr->blist[icoeff]; - numneigh_sum += ninside; + numneigh_sum += ninside; } } // if (mask[i] & groupbit) diff --git a/src/ML-SNAP/compute_snap.h b/src/ML-SNAP/compute_snap.h index 7f7252eaa8..4ef714190c 100644 --- a/src/ML-SNAP/compute_snap.h +++ b/src/ML-SNAP/compute_snap.h @@ -53,7 +53,6 @@ class ComputeSnap : public Compute { double cutmax; int quadraticflag; int bikflag, bik_rows, dgradflag, dgrad_rows; - int rank; Compute *c_pe; Compute *c_virial; From c838c9da6f2751520c9d1e574a0c0ae43ef039d1 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Thu, 7 Jul 2022 11:43:39 -0600 Subject: [PATCH 540/585] Cleaned up language --- doc/src/compute_sna_atom.rst | 83 ++++++++++++++++++++---------------- 1 file changed, 47 insertions(+), 36 deletions(-) diff --git a/doc/src/compute_sna_atom.rst b/doc/src/compute_sna_atom.rst index fdff250e24..04f9501d1f 100644 --- a/doc/src/compute_sna_atom.rst +++ b/doc/src/compute_sna_atom.rst @@ -68,9 +68,6 @@ Syntax *wselfallflag* value = *0* or *1* *0* = self-contribution only for element of central atom *1* = self-contribution for all elements - *bikflag* value = *0* or *1* (only implemented for compute snap) - *0* = per-atom bispectrum descriptors are summed over atoms - *1* = per-atom bispectrum descriptors are not summed over atoms *switchinnerflag* value = *0* or *1* *0* = do not use inner switching function *1* = use inner switching function @@ -78,9 +75,12 @@ Syntax *sinnerlist* = *ntypes* values of *Sinner* (distance units) *dinner* values = *dinnerlist* *dinnerlist* = *ntypes* values of *Dinner* (distance units) - *dgradflag* value = *0* or *1* - *0* = bispectrum descriptor gradients are summed over neighbors - *1* = bispectrum descriptor gradients are not summed over neighbors + *bikflag* value = *0* or *1* (only implemented for compute snap) + *0* = descriptors are summed over atoms of each type + *1* = descriptors are listed separately for each atom + *dgradflag* value = *0* or *1* (only implemented for compute snap) + *0* = descriptor gradients are summed over atoms of each type + *1* = descriptor gradients are listed separately for each atom pair Examples """""""" @@ -363,15 +363,6 @@ This option is typically used in conjunction with the *chem* keyword, and LAMMPS will generate a warning if both *chem* and *bnormflag* are not both set or not both unset. -The keyword *bikflag* determines whether or not to expand the bispectrum -rows of the global array returned by compute snap. If *bikflag* is set -to *1* then the bispectrum row, which is typically the per-atom bispectrum -descriptors :math:`B_{i,k}` summed over all atoms *i* to produce -:math:`B_k`, becomes bispectrum rows equal to the number of atoms. Thus, -the resulting bispectrum rows are :math:`B_{i,k}` instead of just -:math:`B_k`. In this case, the entries in the final column for these rows -are set to zero. - The keyword *switchinnerflag* with value 1 activates an additional radial switching function similar to :math:`f_c(r)` above, but acting to switch off @@ -396,16 +387,36 @@ When the central atom and the neighbor atom have different types, the values of :math:`S_{inner}` and :math:`D_{inner}` are the arithmetic means of the values for both types. -The keyword *dgradflag* determines whether or not to sum the bispectrum -descriptor gradients over neighboring atoms *i'* as explained with *snad/atom* -above. If *dgradflag* is set to 1 then the descriptor gradient rows of the -global snap array are not summed over atoms *i'*. Instead, each row corresponds +The keywords *bikflag* and *dgradflag* are only used by compute *snap*. +The keyword *bikflag* determines whether or not to list the descriptors +of each atom separately, or sum them together and list in a single row. +If *bikflag* is set +to *0* then a single bispectrum row is used, which contains the per-atom bispectrum +descriptors :math:`B_{i,k}` summed over all atoms *i* to produce +:math:`B_k`. If *bikflag* is set +to *1* this is replaced by a separate bispectrum row equal for each atom. +In this case, the entries in the final column for these rows +are set to zero. + +The keyword *dgradflag* determines whether to sum atom gradients or list +them separately. If *dgradflag* is set to 0, the bispectrum +descriptor gradients w.r.t. atom *j* are summed over all atoms *i'* +of type *I* (similar to *snad/atom* above). +If *dgradflag* is set to 1, gradients are listed separately for each pair of atoms. +Each row corresponds to a single term :math:`\frac{\partial {B_{i,k} }}{\partial {r}^a_j}` -where :math:`a` is the Cartesian direction for the gradient. This also changes +where :math:`{r}^a_j` is the *a-th* position coordinate of the atom with global +index *j*. This also changes the number of columns to be equal to the number of bispectrum components, with 3 additional columns representing the indices :math:`i`, :math:`j`, and :math:`a`, as explained more in the Output info section below. The option *dgradflag=1* -must be used with *bikflag=1*. +requires that *bikflag=1*.[APT: This does not make any sense, since dgradflag +produces its own custom output with no bikflag output] + +.. note:: + + Using *dgradflag* = 1 produces a global array with :math:`N + 3N^2 + 1` rows + which becomes expensive for systems with more than 1000 atoms. .. note:: @@ -517,31 +528,31 @@ components. For the purposes of handling contributions to force, virial, and quadratic combinations, these :math:`N_{elem}^3` sub-blocks are treated as a single block of :math:`K N_{elem}^3` columns. -If the *bik* keyword is set to 1, then the first :math:`N` rows of the snap array -correspond to :math:`B_{i,k}` instead of the sum over atoms :math:`i`. In this case, the entries in the final column for these rows -are set to zero. +If the *bik* keyword is set to 1, the structure of the snap array is expanded. +The first :math:`N` rows of the snap array +correspond to :math:`B_{i,k}` instead of a single row summed over atoms :math:`i`. +In this case, the entries in the final column for these rows +are set to zero. Also, each row contains only non-zero entries for the +columns corresponding to the type of that atom. -If the *dgradflag* keyword is set to 1, this changes the structure of the snap array completely. -Here the *snad/atom* quantities are replaced with rows corresponding to descriptor -gradient components +If the *dgradflag* keyword is set to 1, this changes the structure of the +snap array completely. +Here the *snad/atom* quantities are replaced with rows corresponding to +descriptor gradient components on single atoms: .. math:: \frac{\partial {B_{i,k} }}{\partial {r}^a_j} -where :math:`a` is the Cartesian direction for the gradient. The rows are +where :math:`{r}^a_j` is the *a-th* position coordinate of the atom with global +index *j*. The rows are organized in chunks, where each chunk corresponds to an atom :math:`j` in the system of :math:`N` atoms. The rows in an atom :math:`j` chunk correspond to atoms :math:`i` in the system of :math:`N` atoms. The total number of rows for these descriptor gradients is therefore :math:`3N^2`. - -For *dgradflag=1*, the number of columns is equal to the number of bispectrum components, -plus 3 additional columns representing the indices :math:`i`, :math:`j`, and :math:`a` which -identify the atoms :math:`i` and :math:`j`, and Cartesian direction :math:`a` for which -a particular gradient :math:`\frac{\partial {B_{i,k} }}{\partial {r}^a_j}` belongs to. -For the descriptor gradient rows, the first 3 columns contain the indices -:math:`i`, :math:`j`, and :math:`a`, and the remaining columns contain gradients -of different descriptors indexed by :math:`k`. +The number of columns is equal to the number of bispectrum components, +plus 3 additional columns representing the global atom indices :math:`i`, :math:`j`, +and Cartesian direction :math:`a` (0, 1, 2, for x, y, z). The first 3 columns of the first :math:`N` rows belong to the reference potential force components. The first column of the last row, after the first :math:`N + 3N^2` rows, contains the reference potential From b47e5a8d5b79b9780b6ae24940005980c5eca9d4 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Thu, 7 Jul 2022 13:36:22 -0600 Subject: [PATCH 541/585] Finalized doc page --- doc/src/compute_sna_atom.rst | 24 +- src/ML-SNAP/compute_snap.cpp | 720 ----------------------------------- 2 files changed, 14 insertions(+), 730 deletions(-) delete mode 100644 src/ML-SNAP/compute_snap.cpp diff --git a/doc/src/compute_sna_atom.rst b/doc/src/compute_sna_atom.rst index 04f9501d1f..f4d2983997 100644 --- a/doc/src/compute_sna_atom.rst +++ b/doc/src/compute_sna_atom.rst @@ -394,7 +394,7 @@ If *bikflag* is set to *0* then a single bispectrum row is used, which contains the per-atom bispectrum descriptors :math:`B_{i,k}` summed over all atoms *i* to produce :math:`B_k`. If *bikflag* is set -to *1* this is replaced by a separate bispectrum row equal for each atom. +to *1* this is replaced by a separate per-atom bispectrum row for each atom. In this case, the entries in the final column for these rows are set to zero. @@ -410,8 +410,7 @@ index *j*. This also changes the number of columns to be equal to the number of bispectrum components, with 3 additional columns representing the indices :math:`i`, :math:`j`, and :math:`a`, as explained more in the Output info section below. The option *dgradflag=1* -requires that *bikflag=1*.[APT: This does not make any sense, since dgradflag -produces its own custom output with no bikflag output] +requires that *bikflag=1*. .. note:: @@ -533,10 +532,11 @@ The first :math:`N` rows of the snap array correspond to :math:`B_{i,k}` instead of a single row summed over atoms :math:`i`. In this case, the entries in the final column for these rows are set to zero. Also, each row contains only non-zero entries for the -columns corresponding to the type of that atom. +columns corresponding to the type of that atom. This is not true in the case +of *dgradflag* keyword = 1 (see below). If the *dgradflag* keyword is set to 1, this changes the structure of the -snap array completely. +gloabl array completely. Here the *snad/atom* quantities are replaced with rows corresponding to descriptor gradient components on single atoms: @@ -546,15 +546,19 @@ descriptor gradient components on single atoms: where :math:`{r}^a_j` is the *a-th* position coordinate of the atom with global index *j*. The rows are -organized in chunks, where each chunk corresponds to an atom :math:`j` in the -system of :math:`N` atoms. The rows in an atom :math:`j` chunk correspond to -atoms :math:`i` in the system of :math:`N` atoms. The total number of rows for +organized in chunks, where each chunk corresponds to an atom with global index +:math:`j`. The rows in an atom :math:`j` chunk correspond to +atoms with global index :math:`i`. The total number of rows for these descriptor gradients is therefore :math:`3N^2`. The number of columns is equal to the number of bispectrum components, -plus 3 additional columns representing the global atom indices :math:`i`, :math:`j`, +plus 3 additional left-most columns representing the global atom indices +:math:`i`, :math:`j`, and Cartesian direction :math:`a` (0, 1, 2, for x, y, z). The first 3 columns of the first :math:`N` rows belong to the reference -potential force components. The first column of the last row, after the first +potential force components. The remaining K columns contain the +:math:`B_{i,k}` per-atom descriptors corresponding to the non-zero entries +obtained when *bikflag* = 1. +The first column of the last row, after the first :math:`N + 3N^2` rows, contains the reference potential energy. The virial components are not used with this option. The total number of rows is therefore :math:`N + 3N^2 + 1` and the number of columns is :math:`K + 3`. diff --git a/src/ML-SNAP/compute_snap.cpp b/src/ML-SNAP/compute_snap.cpp deleted file mode 100644 index dca3fd3c01..0000000000 --- a/src/ML-SNAP/compute_snap.cpp +++ /dev/null @@ -1,720 +0,0 @@ -// clang-format off -/* ---------------------------------------------------------------------- - LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator - https://www.lammps.org/, Sandia National Laboratories - Steve Plimpton, sjplimp@sandia.gov - - Copyright (2003) Sandia Corporation. Under the terms of Contract - DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains - certain rights in this software. This software is distributed under - the GNU General Public License. - - See the README file in the top-level LAMMPS directory. -------------------------------------------------------------------------- */ - -#include "compute_snap.h" -#include "sna.h" -#include "atom.h" -#include "update.h" -#include "modify.h" -#include "neighbor.h" -#include "neigh_list.h" -#include "force.h" -#include "pair.h" -#include "comm.h" -#include "memory.h" -#include "error.h" - -#include - -using namespace LAMMPS_NS; - -enum{SCALAR,VECTOR,ARRAY}; - -ComputeSnap::ComputeSnap(LAMMPS *lmp, int narg, char **arg) : - Compute(lmp, narg, arg), cutsq(nullptr), list(nullptr), snap(nullptr), - snapall(nullptr), snap_peratom(nullptr), radelem(nullptr), wjelem(nullptr), - sinnerelem(nullptr), dinnerelem(nullptr), snaptr(nullptr) -{ - - array_flag = 1; - extarray = 0; - - // begin code common to all SNAP computes - - double rfac0, rmin0; - int twojmax, switchflag, bzeroflag, bnormflag, wselfallflag; - - int ntypes = atom->ntypes; - int nargmin = 6 + 2 * ntypes; - - if (narg < nargmin) error->all(FLERR, "Illegal compute {} command", style); - - // default values - - rmin0 = 0.0; - switchflag = 1; - bzeroflag = 1; - quadraticflag = 0; - bikflag = 0; - dgradflag = 0; - chemflag = 0; - bnormflag = 0; - wselfallflag = 0; - switchinnerflag = 0; - nelements = 1; - - // process required arguments - - memory->create(radelem, ntypes + 1, "sna/atom:radelem"); // offset by 1 to match up with types - memory->create(wjelem, ntypes + 1, "sna/atom:wjelem"); - - rcutfac = utils::numeric(FLERR, arg[3], false, lmp); - rfac0 = utils::numeric(FLERR, arg[4], false, lmp); - twojmax = utils::inumeric(FLERR, arg[5], false, lmp); - - for (int i = 0; i < ntypes; i++) - radelem[i + 1] = utils::numeric(FLERR, arg[6 + i], false, lmp); - for (int i = 0; i < ntypes; i++) - wjelem[i + 1] = utils::numeric(FLERR, arg[6 + ntypes + i], false, lmp); - - // construct cutsq - - double cut; - cutmax = 0.0; - memory->create(cutsq, ntypes + 1, ntypes + 1, "sna/atom:cutsq"); - for (int i = 1; i <= ntypes; i++) { - cut = 2.0 * radelem[i] * rcutfac; - if (cut > cutmax) cutmax = cut; - cutsq[i][i] = cut * cut; - for (int j = i + 1; j <= ntypes; j++) { - cut = (radelem[i] + radelem[j]) * rcutfac; - cutsq[i][j] = cutsq[j][i] = cut * cut; - } - } - - // set local input checks - - int sinnerflag = 0; - int dinnerflag = 0; - - // process optional args - - int iarg = nargmin; - - while (iarg < narg) { - if (strcmp(arg[iarg], "rmin0") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); - rmin0 = utils::numeric(FLERR, arg[iarg + 1], false, lmp); - iarg += 2; - } else if (strcmp(arg[iarg], "switchflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); - switchflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); - iarg += 2; - } else if (strcmp(arg[iarg], "bzeroflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); - bzeroflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); - iarg += 2; - } else if (strcmp(arg[iarg], "quadraticflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); - quadraticflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); - iarg += 2; - } else if (strcmp(arg[iarg], "chem") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); - chemflag = 1; - memory->create(map, ntypes + 1, "compute_sna_grid:map"); - nelements = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); - for (int i = 0; i < ntypes; i++) { - int jelem = utils::inumeric(FLERR, arg[iarg + 2 + i], false, lmp); - if (jelem < 0 || jelem >= nelements) error->all(FLERR, "Illegal compute {} command", style); - map[i + 1] = jelem; - } - iarg += 2 + ntypes; - } else if (strcmp(arg[iarg], "bnormflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); - bnormflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); - iarg += 2; - } else if (strcmp(arg[iarg], "wselfallflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); - wselfallflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); - iarg += 2; - } else if (strcmp(arg[iarg], "bikflag") == 0) { - if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); - bikflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); - iarg += 2; - } else if (strcmp(arg[iarg],"dgradflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute snap command"); - dgradflag = atoi(arg[iarg+1]); - iarg += 2; - } else if (strcmp(arg[iarg],"switchinnerflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute snap command"); - switchinnerflag = atoi(arg[iarg+1]); - iarg += 2; - } else if (strcmp(arg[iarg], "sinner") == 0) { - iarg++; - if (iarg + ntypes > narg) error->all(FLERR, "Illegal compute {} command", style); - memory->create(sinnerelem, ntypes + 1, "snap:sinnerelem"); - for (int i = 0; i < ntypes; i++) - sinnerelem[i + 1] = utils::numeric(FLERR, arg[iarg + i], false, lmp); - sinnerflag = 1; - iarg += ntypes; - } else if (strcmp(arg[iarg], "dinner") == 0) { - iarg++; - if (iarg + ntypes > narg) error->all(FLERR, "Illegal compute {} command", style); - memory->create(dinnerelem, ntypes + 1, "snap:dinnerelem"); - for (int i = 0; i < ntypes; i++) - dinnerelem[i + 1] = utils::numeric(FLERR, arg[iarg + i], false, lmp); - dinnerflag = 1; - iarg += ntypes; - } else - error->all(FLERR, "Illegal compute {} command", style); - } - - if (switchinnerflag && !(sinnerflag && dinnerflag)) - error->all( - FLERR, - "Illegal compute {} command: switchinnerflag = 1, missing sinner/dinner keyword", - style); - - if (!switchinnerflag && (sinnerflag || dinnerflag)) - error->all( - FLERR, - "Illegal compute {} command: switchinnerflag = 0, unexpected sinner/dinner keyword", - style); - - if (dgradflag && !bikflag) - error->all(FLERR,"Illegal compute snap command: dgradflag=1 requires bikflag=1"); - - if (dgradflag && quadraticflag) - error->all(FLERR,"Illegal compute snap command: dgradflag=1 not implemented for quadratic SNAP"); - - snaptr = new SNA(lmp, rfac0, twojmax, - rmin0, switchflag, bzeroflag, - chemflag, bnormflag, wselfallflag, - nelements, switchinnerflag); - - ncoeff = snaptr->ncoeff; - nvalues = ncoeff; - if (quadraticflag) nvalues += (ncoeff * (ncoeff + 1)) / 2; - - // end code common to all SNAP computes - - ndims_force = 3; - ndims_virial = 6; - yoffset = nvalues; - zoffset = 2 * nvalues; - natoms = atom->natoms; - bik_rows = 1; - if (bikflag) bik_rows = natoms; - dgrad_rows = ndims_force*natoms; - size_array_rows = bik_rows+dgrad_rows + ndims_virial; - if (dgradflag){ - size_array_rows = bik_rows + 3*natoms*natoms + 1; - size_array_cols = nvalues + 3; - error->warning(FLERR,"dgradflag=1 creates a N^2 array, beware of large systems."); - } - else size_array_cols = nvalues*atom->ntypes + 1; - lastcol = size_array_cols-1; - - ndims_peratom = ndims_force; - size_peratom = ndims_peratom*nvalues*atom->ntypes; - - nmax = 0; -} - -/* ---------------------------------------------------------------------- */ - -ComputeSnap::~ComputeSnap() -{ - - memory->destroy(snap); - memory->destroy(snapall); - memory->destroy(snap_peratom); - memory->destroy(radelem); - memory->destroy(wjelem); - memory->destroy(cutsq); - delete snaptr; - if (chemflag) memory->destroy(map); - - if (switchinnerflag) { - memory->destroy(sinnerelem); - memory->destroy(dinnerelem); - } - -} - -/* ---------------------------------------------------------------------- */ - -void ComputeSnap::init() -{ - if (force->pair == nullptr) - error->all(FLERR,"Compute snap requires a pair style be defined"); - - if (cutmax > force->pair->cutforce){ - error->all(FLERR,"Compute snap cutoff is longer than pairwise cutoff"); - } - - // need an occasional full neighbor list - - neighbor->add_request(this, NeighConst::REQ_FULL | NeighConst::REQ_OCCASIONAL); - - if (modify->get_compute_by_style("snap").size() > 1 && comm->me == 0) - error->warning(FLERR,"More than one compute snap"); - snaptr->init(); - - // allocate memory for global array - - memory->create(snap,size_array_rows,size_array_cols, - "snap:snap"); - memory->create(snapall,size_array_rows,size_array_cols, - "snap:snapall"); - array = snapall; - - // find compute for reference energy - - std::string id_pe = std::string("thermo_pe"); - int ipe = modify->find_compute(id_pe); - if (ipe == -1) - error->all(FLERR,"compute thermo_pe does not exist."); - c_pe = modify->compute[ipe]; - - // add compute for reference virial tensor - - std::string id_virial = std::string("snap_press"); - std::string pcmd = id_virial + " all pressure NULL virial"; - modify->add_compute(pcmd); - - int ivirial = modify->find_compute(id_virial); - if (ivirial == -1) - error->all(FLERR,"compute snap_press does not exist."); - c_virial = modify->compute[ivirial]; - -} - - -/* ---------------------------------------------------------------------- */ - -void ComputeSnap::init_list(int /*id*/, NeighList *ptr) -{ - list = ptr; -} - -/* ---------------------------------------------------------------------- */ - -void ComputeSnap::compute_array() -{ - - int ntotal = atom->nlocal + atom->nghost; - - invoked_array = update->ntimestep; - - // grow snap_peratom array if necessary - - if (atom->nmax > nmax) { - memory->destroy(snap_peratom); - nmax = atom->nmax; - memory->create(snap_peratom,nmax,size_peratom, - "snap:snap_peratom"); - } - - // clear global array - - for (int irow = 0; irow < size_array_rows; irow++){ - for (int icoeff = 0; icoeff < size_array_cols; icoeff++){ - snap[irow][icoeff] = 0.0; - } - } - - // clear local peratom array - for (int i = 0; i < ntotal; i++) - for (int icoeff = 0; icoeff < size_peratom; icoeff++) { - snap_peratom[i][icoeff] = 0.0; - } - - // invoke full neighbor list (will copy or build if necessary) - - neighbor->build_one(list); - - const int inum = list->inum; - const int* const ilist = list->ilist; - const int* const numneigh = list->numneigh; - int** const firstneigh = list->firstneigh; - int * const type = atom->type; - - // compute sna derivatives for each atom in group - // use full neighbor list to count atoms less than cutoff - - double** const x = atom->x; - const int* const mask = atom->mask; - int ninside; - int numneigh_sum = 0; - int dgrad_row_indx; - for (int ii = 0; ii < inum; ii++) { - int irow = 0; - if (bikflag) irow = atom->tag[ilist[ii] & NEIGHMASK]-1; - const int i = ilist[ii]; - if (mask[i] & groupbit) { - - const double xtmp = x[i][0]; - const double ytmp = x[i][1]; - const double ztmp = x[i][2]; - const int itype = type[i]; - int ielem = 0; - if (chemflag) - ielem = map[itype]; - const double radi = radelem[itype]; - const int* const jlist = firstneigh[i]; - const int jnum = numneigh[i]; - const int typeoffset_local = ndims_peratom*nvalues*(itype-1); - const int typeoffset_global = nvalues*(itype-1); - - if (dgradflag){ - - // dBi/dRi tags - - snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 0][0] = atom->tag[i]-1; - snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 0][1] = atom->tag[i]-1; - snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 0][2] = 0; - snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 1][0] = atom->tag[i]-1; - snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 1][1] = atom->tag[i]-1; - snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 1][2] = 1; - snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 2][0] = atom->tag[i]-1; - snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 2][1] = atom->tag[i]-1; - snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 2][2] = 2; - - // dBi/dRj tags - - for (int j=0; jtag[i]-1) + 0][0] = atom->tag[i]-1; - snap[bik_rows + ((j)*3*natoms) + 3*(atom->tag[i]-1) + 0][1] = j; - snap[bik_rows + ((j)*3*natoms) + 3*(atom->tag[i]-1) + 0][2] = 0; - snap[bik_rows + ((j)*3*natoms) + 3*(atom->tag[i]-1) + 1][0] = atom->tag[i]-1; - snap[bik_rows + ((j)*3*natoms) + 3*(atom->tag[i]-1) + 1][1] = j; - snap[bik_rows + ((j)*3*natoms) + 3*(atom->tag[i]-1) + 1][2] = 1; - snap[bik_rows + ((j)*3*natoms) + 3*(atom->tag[i]-1) + 2][0] = atom->tag[i]-1; - snap[bik_rows + ((j)*3*natoms) + 3*(atom->tag[i]-1) + 2][1] = j; - snap[bik_rows + ((j)*3*natoms) + 3*(atom->tag[i]-1) + 2][2] = 2; - } - } - - // insure rij, inside, and typej are of size jnum - - snaptr->grow_rij(jnum); - - // rij[][3] = displacements between atom I and those neighbors - // inside = indices of neighbors of I within cutoff - // typej = types of neighbors of I within cutoff - // note Rij sign convention => dU/dRij = dU/dRj = -dU/dRi - - // assign quantities in snaptr - - ninside=0; - for (int jj = 0; jj < jnum; jj++) { - int j = jlist[jj]; - j &= NEIGHMASK; - - const double delx = x[j][0] - xtmp; - const double dely = x[j][1] - ytmp; - const double delz = x[j][2] - ztmp; - const double rsq = delx*delx + dely*dely + delz*delz; - int jtype = type[j]; - int jelem = 0; - if (chemflag) - jelem = map[jtype]; - if (rsq < cutsq[itype][jtype]&&rsq>1e-20) { - snaptr->rij[ninside][0] = delx; - snaptr->rij[ninside][1] = dely; - snaptr->rij[ninside][2] = delz; - snaptr->inside[ninside] = j; - snaptr->wj[ninside] = wjelem[jtype]; - snaptr->rcutij[ninside] = (radi+radelem[jtype])*rcutfac; - if (switchinnerflag) { - snaptr->sinnerij[ninside] = 0.5*(sinnerelem[itype]+sinnerelem[jtype]); - snaptr->dinnerij[ninside] = 0.5*(dinnerelem[itype]+dinnerelem[jtype]); - } - if (chemflag) snaptr->element[ninside] = jelem; - ninside++; - } - } - - // compute bispectrum for atom i - - snaptr->compute_ui(ninside, ielem); - snaptr->compute_zi(); - snaptr->compute_bi(ielem); - - // loop over neighbors for descriptors derivatives - - for (int jj = 0; jj < ninside; jj++) { - const int j = snaptr->inside[jj]; - - snaptr->compute_duidrj(jj); - snaptr->compute_dbidrj(); - - // accumulate dBi/dRi, -dBi/dRj - - if (!dgradflag) { - - double *snadi = snap_peratom[i]+typeoffset_local; - double *snadj = snap_peratom[j]+typeoffset_local; - - for (int icoeff = 0; icoeff < ncoeff; icoeff++) { - - snadi[icoeff] += snaptr->dblist[icoeff][0]; - snadi[icoeff+yoffset] += snaptr->dblist[icoeff][1]; - snadi[icoeff+zoffset] += snaptr->dblist[icoeff][2]; - - snadj[icoeff] -= snaptr->dblist[icoeff][0]; - snadj[icoeff+yoffset] -= snaptr->dblist[icoeff][1]; - snadj[icoeff+zoffset] -= snaptr->dblist[icoeff][2]; - } - - if (quadraticflag) { - const int quadraticoffset = ncoeff; - snadi += quadraticoffset; - snadj += quadraticoffset; - int ncount = 0; - for (int icoeff = 0; icoeff < ncoeff; icoeff++) { - double bi = snaptr->blist[icoeff]; - double bix = snaptr->dblist[icoeff][0]; - double biy = snaptr->dblist[icoeff][1]; - double biz = snaptr->dblist[icoeff][2]; - - // diagonal elements of quadratic matrix - - double dbxtmp = bi*bix; - double dbytmp = bi*biy; - double dbztmp = bi*biz; - - snadi[ncount] += dbxtmp; - snadi[ncount+yoffset] += dbytmp; - snadi[ncount+zoffset] += dbztmp; - snadj[ncount] -= dbxtmp; - snadj[ncount+yoffset] -= dbytmp; - snadj[ncount+zoffset] -= dbztmp; - - ncount++; - - // upper-triangular elements of quadratic matrix - - for (int jcoeff = icoeff+1; jcoeff < ncoeff; jcoeff++) { - double dbxtmp = bi*snaptr->dblist[jcoeff][0] - + bix*snaptr->blist[jcoeff]; - double dbytmp = bi*snaptr->dblist[jcoeff][1] - + biy*snaptr->blist[jcoeff]; - double dbztmp = bi*snaptr->dblist[jcoeff][2] - + biz*snaptr->blist[jcoeff]; - - snadi[ncount] += dbxtmp; - snadi[ncount+yoffset] += dbytmp; - snadi[ncount+zoffset] += dbztmp; - snadj[ncount] -= dbxtmp; - snadj[ncount+yoffset] -= dbytmp; - snadj[ncount+zoffset] -= dbztmp; - - ncount++; - } - } - } - } else { - - for (int icoeff = 0; icoeff < ncoeff; icoeff++) { - - // add to snap array for this proc - - // dBi/dRj - - snap[bik_rows + ((atom->tag[j]-1)*3*natoms) + 3*(atom->tag[i]-1) + 0][icoeff+3] -= snaptr->dblist[icoeff][0]; - snap[bik_rows + ((atom->tag[j]-1)*3*natoms) + 3*(atom->tag[i]-1) + 1][icoeff+3] -= snaptr->dblist[icoeff][1]; - snap[bik_rows + ((atom->tag[j]-1)*3*natoms) + 3*(atom->tag[i]-1) + 2][icoeff+3] -= snaptr->dblist[icoeff][2]; - - // dBi/dRi - - snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 0][icoeff+3] += snaptr->dblist[icoeff][0]; - snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 1][icoeff+3] += snaptr->dblist[icoeff][1]; - snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 2][icoeff+3] += snaptr->dblist[icoeff][2]; - } - - } - - } // loop over jj inside - - // accumulate Bi - - if (!dgradflag) { - - // linear contributions - - int k = typeoffset_global; - for (int icoeff = 0; icoeff < ncoeff; icoeff++) - snap[irow][k++] += snaptr->blist[icoeff]; - - // quadratic contributions - - if (quadraticflag) { - for (int icoeff = 0; icoeff < ncoeff; icoeff++) { - double bveci = snaptr->blist[icoeff]; - snap[irow][k++] += 0.5*bveci*bveci; - for (int jcoeff = icoeff+1; jcoeff < ncoeff; jcoeff++) { - double bvecj = snaptr->blist[jcoeff]; - snap[irow][k++] += bveci*bvecj; - } - } - } - - } else { - int k = 3; - for (int icoeff = 0; icoeff < ncoeff; icoeff++) - snap[irow][k++] += snaptr->blist[icoeff]; - numneigh_sum += ninside; - } - - } // if (mask[i] & groupbit) - - } // for (int ii = 0; ii < inum; ii++) { - - // accumulate bispectrum force contributions to global array - - if (!dgradflag) { - - for (int itype = 0; itype < atom->ntypes; itype++) { - const int typeoffset_local = ndims_peratom*nvalues*itype; - const int typeoffset_global = nvalues*itype; - for (int icoeff = 0; icoeff < nvalues; icoeff++) { - for (int i = 0; i < ntotal; i++) { - double *snadi = snap_peratom[i]+typeoffset_local; - int iglobal = atom->tag[i]; - int irow = 3*(iglobal-1)+bik_rows; - snap[irow++][icoeff+typeoffset_global] += snadi[icoeff]; - snap[irow++][icoeff+typeoffset_global] += snadi[icoeff+yoffset]; - snap[irow][icoeff+typeoffset_global] += snadi[icoeff+zoffset]; - } - } - } - - } - - // accumulate forces to global array - - if (!dgradflag) { - for (int i = 0; i < atom->nlocal; i++) { - int iglobal = atom->tag[i]; - int irow = 3*(iglobal-1)+bik_rows; - snap[irow++][lastcol] = atom->f[i][0]; - snap[irow++][lastcol] = atom->f[i][1]; - snap[irow][lastcol] = atom->f[i][2]; - } - - } else { - - // for dgradflag=1, put forces at first 3 columns of bik rows - - for (int i=0; inlocal; i++){ - int iglobal = atom->tag[i]; - snap[iglobal-1][0+0] = atom->f[i][0]; - snap[iglobal-1][0+1] = atom->f[i][1]; - snap[iglobal-1][0+2] = atom->f[i][2]; - } - } - - // accumulate bispectrum virial contributions to global array - - dbdotr_compute(); - - // sum up over all processes - - MPI_Allreduce(&snap[0][0],&snapall[0][0],size_array_rows*size_array_cols,MPI_DOUBLE,MPI_SUM,world); - - // assign energy to last column - - if (!dgradflag) { - for (int i = 0; i < bik_rows; i++) snapall[i][lastcol] = 0; - int irow = 0; - double reference_energy = c_pe->compute_scalar(); - snapall[irow][lastcol] = reference_energy; - - } else { - - // assign reference energy right after the dgrad rows, first column - - int irow = bik_rows + 3*natoms*natoms; - double reference_energy = c_pe->compute_scalar(); - snapall[irow][0] = reference_energy; - } - - // assign virial stress to last column - // switch to Voigt notation - - if (!dgradflag) { - c_virial->compute_vector(); - int irow = 3*natoms+bik_rows; - snapall[irow++][lastcol] = c_virial->vector[0]; - snapall[irow++][lastcol] = c_virial->vector[1]; - snapall[irow++][lastcol] = c_virial->vector[2]; - snapall[irow++][lastcol] = c_virial->vector[5]; - snapall[irow++][lastcol] = c_virial->vector[4]; - snapall[irow][lastcol] = c_virial->vector[3]; - } - -} - -/* ---------------------------------------------------------------------- - compute global virial contributions via summing r_i.dB^j/dr_i over - own & ghost atoms -------------------------------------------------------------------------- */ - -void ComputeSnap::dbdotr_compute() -{ - - // no virial terms for dgrad yet - - if (dgradflag) return; - - double **x = atom->x; - - int irow0 = bik_rows+ndims_force*natoms; - - // sum over bispectrum contributions to forces - // on all particles including ghosts - - int nall = atom->nlocal + atom->nghost; - for (int i = 0; i < nall; i++) - for (int itype = 0; itype < atom->ntypes; itype++) { - const int typeoffset_local = ndims_peratom*nvalues*itype; - const int typeoffset_global = nvalues*itype; - double *snadi = snap_peratom[i]+typeoffset_local; - for (int icoeff = 0; icoeff < nvalues; icoeff++) { - double dbdx = snadi[icoeff]; - double dbdy = snadi[icoeff+yoffset]; - double dbdz = snadi[icoeff+zoffset]; - int irow = irow0; - snap[irow++][icoeff+typeoffset_global] += dbdx*x[i][0]; - snap[irow++][icoeff+typeoffset_global] += dbdy*x[i][1]; - snap[irow++][icoeff+typeoffset_global] += dbdz*x[i][2]; - snap[irow++][icoeff+typeoffset_global] += dbdz*x[i][1]; - snap[irow++][icoeff+typeoffset_global] += dbdz*x[i][0]; - snap[irow][icoeff+typeoffset_global] += dbdy*x[i][0]; - } - } -} - -/* ---------------------------------------------------------------------- - memory usage -------------------------------------------------------------------------- */ - -double ComputeSnap::memory_usage() -{ - - double bytes = (double)size_array_rows*size_array_cols * - sizeof(double); // snap - bytes += (double)size_array_rows*size_array_cols * - sizeof(double); // snapall - bytes += (double)nmax*size_peratom * sizeof(double); // snap_peratom - bytes += snaptr->memory_usage(); // SNA object - int n = atom->ntypes+1; - bytes += (double)n*sizeof(int); // map - - return bytes; -} From 9aa819d91e6107acb49d601cff703bd99db76103 Mon Sep 17 00:00:00 2001 From: rohskopf Date: Thu, 7 Jul 2022 13:46:01 -0600 Subject: [PATCH 542/585] Put compute_snap back --- src/ML-SNAP/compute_snap.cpp | 720 +++++++++++++++++++++++++++++++++++ 1 file changed, 720 insertions(+) create mode 100644 src/ML-SNAP/compute_snap.cpp diff --git a/src/ML-SNAP/compute_snap.cpp b/src/ML-SNAP/compute_snap.cpp new file mode 100644 index 0000000000..dca3fd3c01 --- /dev/null +++ b/src/ML-SNAP/compute_snap.cpp @@ -0,0 +1,720 @@ +// clang-format off +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + https://www.lammps.org/, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#include "compute_snap.h" +#include "sna.h" +#include "atom.h" +#include "update.h" +#include "modify.h" +#include "neighbor.h" +#include "neigh_list.h" +#include "force.h" +#include "pair.h" +#include "comm.h" +#include "memory.h" +#include "error.h" + +#include + +using namespace LAMMPS_NS; + +enum{SCALAR,VECTOR,ARRAY}; + +ComputeSnap::ComputeSnap(LAMMPS *lmp, int narg, char **arg) : + Compute(lmp, narg, arg), cutsq(nullptr), list(nullptr), snap(nullptr), + snapall(nullptr), snap_peratom(nullptr), radelem(nullptr), wjelem(nullptr), + sinnerelem(nullptr), dinnerelem(nullptr), snaptr(nullptr) +{ + + array_flag = 1; + extarray = 0; + + // begin code common to all SNAP computes + + double rfac0, rmin0; + int twojmax, switchflag, bzeroflag, bnormflag, wselfallflag; + + int ntypes = atom->ntypes; + int nargmin = 6 + 2 * ntypes; + + if (narg < nargmin) error->all(FLERR, "Illegal compute {} command", style); + + // default values + + rmin0 = 0.0; + switchflag = 1; + bzeroflag = 1; + quadraticflag = 0; + bikflag = 0; + dgradflag = 0; + chemflag = 0; + bnormflag = 0; + wselfallflag = 0; + switchinnerflag = 0; + nelements = 1; + + // process required arguments + + memory->create(radelem, ntypes + 1, "sna/atom:radelem"); // offset by 1 to match up with types + memory->create(wjelem, ntypes + 1, "sna/atom:wjelem"); + + rcutfac = utils::numeric(FLERR, arg[3], false, lmp); + rfac0 = utils::numeric(FLERR, arg[4], false, lmp); + twojmax = utils::inumeric(FLERR, arg[5], false, lmp); + + for (int i = 0; i < ntypes; i++) + radelem[i + 1] = utils::numeric(FLERR, arg[6 + i], false, lmp); + for (int i = 0; i < ntypes; i++) + wjelem[i + 1] = utils::numeric(FLERR, arg[6 + ntypes + i], false, lmp); + + // construct cutsq + + double cut; + cutmax = 0.0; + memory->create(cutsq, ntypes + 1, ntypes + 1, "sna/atom:cutsq"); + for (int i = 1; i <= ntypes; i++) { + cut = 2.0 * radelem[i] * rcutfac; + if (cut > cutmax) cutmax = cut; + cutsq[i][i] = cut * cut; + for (int j = i + 1; j <= ntypes; j++) { + cut = (radelem[i] + radelem[j]) * rcutfac; + cutsq[i][j] = cutsq[j][i] = cut * cut; + } + } + + // set local input checks + + int sinnerflag = 0; + int dinnerflag = 0; + + // process optional args + + int iarg = nargmin; + + while (iarg < narg) { + if (strcmp(arg[iarg], "rmin0") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); + rmin0 = utils::numeric(FLERR, arg[iarg + 1], false, lmp); + iarg += 2; + } else if (strcmp(arg[iarg], "switchflag") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); + switchflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); + iarg += 2; + } else if (strcmp(arg[iarg], "bzeroflag") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); + bzeroflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); + iarg += 2; + } else if (strcmp(arg[iarg], "quadraticflag") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); + quadraticflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); + iarg += 2; + } else if (strcmp(arg[iarg], "chem") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); + chemflag = 1; + memory->create(map, ntypes + 1, "compute_sna_grid:map"); + nelements = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); + for (int i = 0; i < ntypes; i++) { + int jelem = utils::inumeric(FLERR, arg[iarg + 2 + i], false, lmp); + if (jelem < 0 || jelem >= nelements) error->all(FLERR, "Illegal compute {} command", style); + map[i + 1] = jelem; + } + iarg += 2 + ntypes; + } else if (strcmp(arg[iarg], "bnormflag") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); + bnormflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); + iarg += 2; + } else if (strcmp(arg[iarg], "wselfallflag") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); + wselfallflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); + iarg += 2; + } else if (strcmp(arg[iarg], "bikflag") == 0) { + if (iarg + 2 > narg) error->all(FLERR, "Illegal compute {} command", style); + bikflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); + iarg += 2; + } else if (strcmp(arg[iarg],"dgradflag") == 0) { + if (iarg+2 > narg) + error->all(FLERR,"Illegal compute snap command"); + dgradflag = atoi(arg[iarg+1]); + iarg += 2; + } else if (strcmp(arg[iarg],"switchinnerflag") == 0) { + if (iarg+2 > narg) + error->all(FLERR,"Illegal compute snap command"); + switchinnerflag = atoi(arg[iarg+1]); + iarg += 2; + } else if (strcmp(arg[iarg], "sinner") == 0) { + iarg++; + if (iarg + ntypes > narg) error->all(FLERR, "Illegal compute {} command", style); + memory->create(sinnerelem, ntypes + 1, "snap:sinnerelem"); + for (int i = 0; i < ntypes; i++) + sinnerelem[i + 1] = utils::numeric(FLERR, arg[iarg + i], false, lmp); + sinnerflag = 1; + iarg += ntypes; + } else if (strcmp(arg[iarg], "dinner") == 0) { + iarg++; + if (iarg + ntypes > narg) error->all(FLERR, "Illegal compute {} command", style); + memory->create(dinnerelem, ntypes + 1, "snap:dinnerelem"); + for (int i = 0; i < ntypes; i++) + dinnerelem[i + 1] = utils::numeric(FLERR, arg[iarg + i], false, lmp); + dinnerflag = 1; + iarg += ntypes; + } else + error->all(FLERR, "Illegal compute {} command", style); + } + + if (switchinnerflag && !(sinnerflag && dinnerflag)) + error->all( + FLERR, + "Illegal compute {} command: switchinnerflag = 1, missing sinner/dinner keyword", + style); + + if (!switchinnerflag && (sinnerflag || dinnerflag)) + error->all( + FLERR, + "Illegal compute {} command: switchinnerflag = 0, unexpected sinner/dinner keyword", + style); + + if (dgradflag && !bikflag) + error->all(FLERR,"Illegal compute snap command: dgradflag=1 requires bikflag=1"); + + if (dgradflag && quadraticflag) + error->all(FLERR,"Illegal compute snap command: dgradflag=1 not implemented for quadratic SNAP"); + + snaptr = new SNA(lmp, rfac0, twojmax, + rmin0, switchflag, bzeroflag, + chemflag, bnormflag, wselfallflag, + nelements, switchinnerflag); + + ncoeff = snaptr->ncoeff; + nvalues = ncoeff; + if (quadraticflag) nvalues += (ncoeff * (ncoeff + 1)) / 2; + + // end code common to all SNAP computes + + ndims_force = 3; + ndims_virial = 6; + yoffset = nvalues; + zoffset = 2 * nvalues; + natoms = atom->natoms; + bik_rows = 1; + if (bikflag) bik_rows = natoms; + dgrad_rows = ndims_force*natoms; + size_array_rows = bik_rows+dgrad_rows + ndims_virial; + if (dgradflag){ + size_array_rows = bik_rows + 3*natoms*natoms + 1; + size_array_cols = nvalues + 3; + error->warning(FLERR,"dgradflag=1 creates a N^2 array, beware of large systems."); + } + else size_array_cols = nvalues*atom->ntypes + 1; + lastcol = size_array_cols-1; + + ndims_peratom = ndims_force; + size_peratom = ndims_peratom*nvalues*atom->ntypes; + + nmax = 0; +} + +/* ---------------------------------------------------------------------- */ + +ComputeSnap::~ComputeSnap() +{ + + memory->destroy(snap); + memory->destroy(snapall); + memory->destroy(snap_peratom); + memory->destroy(radelem); + memory->destroy(wjelem); + memory->destroy(cutsq); + delete snaptr; + if (chemflag) memory->destroy(map); + + if (switchinnerflag) { + memory->destroy(sinnerelem); + memory->destroy(dinnerelem); + } + +} + +/* ---------------------------------------------------------------------- */ + +void ComputeSnap::init() +{ + if (force->pair == nullptr) + error->all(FLERR,"Compute snap requires a pair style be defined"); + + if (cutmax > force->pair->cutforce){ + error->all(FLERR,"Compute snap cutoff is longer than pairwise cutoff"); + } + + // need an occasional full neighbor list + + neighbor->add_request(this, NeighConst::REQ_FULL | NeighConst::REQ_OCCASIONAL); + + if (modify->get_compute_by_style("snap").size() > 1 && comm->me == 0) + error->warning(FLERR,"More than one compute snap"); + snaptr->init(); + + // allocate memory for global array + + memory->create(snap,size_array_rows,size_array_cols, + "snap:snap"); + memory->create(snapall,size_array_rows,size_array_cols, + "snap:snapall"); + array = snapall; + + // find compute for reference energy + + std::string id_pe = std::string("thermo_pe"); + int ipe = modify->find_compute(id_pe); + if (ipe == -1) + error->all(FLERR,"compute thermo_pe does not exist."); + c_pe = modify->compute[ipe]; + + // add compute for reference virial tensor + + std::string id_virial = std::string("snap_press"); + std::string pcmd = id_virial + " all pressure NULL virial"; + modify->add_compute(pcmd); + + int ivirial = modify->find_compute(id_virial); + if (ivirial == -1) + error->all(FLERR,"compute snap_press does not exist."); + c_virial = modify->compute[ivirial]; + +} + + +/* ---------------------------------------------------------------------- */ + +void ComputeSnap::init_list(int /*id*/, NeighList *ptr) +{ + list = ptr; +} + +/* ---------------------------------------------------------------------- */ + +void ComputeSnap::compute_array() +{ + + int ntotal = atom->nlocal + atom->nghost; + + invoked_array = update->ntimestep; + + // grow snap_peratom array if necessary + + if (atom->nmax > nmax) { + memory->destroy(snap_peratom); + nmax = atom->nmax; + memory->create(snap_peratom,nmax,size_peratom, + "snap:snap_peratom"); + } + + // clear global array + + for (int irow = 0; irow < size_array_rows; irow++){ + for (int icoeff = 0; icoeff < size_array_cols; icoeff++){ + snap[irow][icoeff] = 0.0; + } + } + + // clear local peratom array + for (int i = 0; i < ntotal; i++) + for (int icoeff = 0; icoeff < size_peratom; icoeff++) { + snap_peratom[i][icoeff] = 0.0; + } + + // invoke full neighbor list (will copy or build if necessary) + + neighbor->build_one(list); + + const int inum = list->inum; + const int* const ilist = list->ilist; + const int* const numneigh = list->numneigh; + int** const firstneigh = list->firstneigh; + int * const type = atom->type; + + // compute sna derivatives for each atom in group + // use full neighbor list to count atoms less than cutoff + + double** const x = atom->x; + const int* const mask = atom->mask; + int ninside; + int numneigh_sum = 0; + int dgrad_row_indx; + for (int ii = 0; ii < inum; ii++) { + int irow = 0; + if (bikflag) irow = atom->tag[ilist[ii] & NEIGHMASK]-1; + const int i = ilist[ii]; + if (mask[i] & groupbit) { + + const double xtmp = x[i][0]; + const double ytmp = x[i][1]; + const double ztmp = x[i][2]; + const int itype = type[i]; + int ielem = 0; + if (chemflag) + ielem = map[itype]; + const double radi = radelem[itype]; + const int* const jlist = firstneigh[i]; + const int jnum = numneigh[i]; + const int typeoffset_local = ndims_peratom*nvalues*(itype-1); + const int typeoffset_global = nvalues*(itype-1); + + if (dgradflag){ + + // dBi/dRi tags + + snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 0][0] = atom->tag[i]-1; + snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 0][1] = atom->tag[i]-1; + snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 0][2] = 0; + snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 1][0] = atom->tag[i]-1; + snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 1][1] = atom->tag[i]-1; + snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 1][2] = 1; + snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 2][0] = atom->tag[i]-1; + snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 2][1] = atom->tag[i]-1; + snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 2][2] = 2; + + // dBi/dRj tags + + for (int j=0; jtag[i]-1) + 0][0] = atom->tag[i]-1; + snap[bik_rows + ((j)*3*natoms) + 3*(atom->tag[i]-1) + 0][1] = j; + snap[bik_rows + ((j)*3*natoms) + 3*(atom->tag[i]-1) + 0][2] = 0; + snap[bik_rows + ((j)*3*natoms) + 3*(atom->tag[i]-1) + 1][0] = atom->tag[i]-1; + snap[bik_rows + ((j)*3*natoms) + 3*(atom->tag[i]-1) + 1][1] = j; + snap[bik_rows + ((j)*3*natoms) + 3*(atom->tag[i]-1) + 1][2] = 1; + snap[bik_rows + ((j)*3*natoms) + 3*(atom->tag[i]-1) + 2][0] = atom->tag[i]-1; + snap[bik_rows + ((j)*3*natoms) + 3*(atom->tag[i]-1) + 2][1] = j; + snap[bik_rows + ((j)*3*natoms) + 3*(atom->tag[i]-1) + 2][2] = 2; + } + } + + // insure rij, inside, and typej are of size jnum + + snaptr->grow_rij(jnum); + + // rij[][3] = displacements between atom I and those neighbors + // inside = indices of neighbors of I within cutoff + // typej = types of neighbors of I within cutoff + // note Rij sign convention => dU/dRij = dU/dRj = -dU/dRi + + // assign quantities in snaptr + + ninside=0; + for (int jj = 0; jj < jnum; jj++) { + int j = jlist[jj]; + j &= NEIGHMASK; + + const double delx = x[j][0] - xtmp; + const double dely = x[j][1] - ytmp; + const double delz = x[j][2] - ztmp; + const double rsq = delx*delx + dely*dely + delz*delz; + int jtype = type[j]; + int jelem = 0; + if (chemflag) + jelem = map[jtype]; + if (rsq < cutsq[itype][jtype]&&rsq>1e-20) { + snaptr->rij[ninside][0] = delx; + snaptr->rij[ninside][1] = dely; + snaptr->rij[ninside][2] = delz; + snaptr->inside[ninside] = j; + snaptr->wj[ninside] = wjelem[jtype]; + snaptr->rcutij[ninside] = (radi+radelem[jtype])*rcutfac; + if (switchinnerflag) { + snaptr->sinnerij[ninside] = 0.5*(sinnerelem[itype]+sinnerelem[jtype]); + snaptr->dinnerij[ninside] = 0.5*(dinnerelem[itype]+dinnerelem[jtype]); + } + if (chemflag) snaptr->element[ninside] = jelem; + ninside++; + } + } + + // compute bispectrum for atom i + + snaptr->compute_ui(ninside, ielem); + snaptr->compute_zi(); + snaptr->compute_bi(ielem); + + // loop over neighbors for descriptors derivatives + + for (int jj = 0; jj < ninside; jj++) { + const int j = snaptr->inside[jj]; + + snaptr->compute_duidrj(jj); + snaptr->compute_dbidrj(); + + // accumulate dBi/dRi, -dBi/dRj + + if (!dgradflag) { + + double *snadi = snap_peratom[i]+typeoffset_local; + double *snadj = snap_peratom[j]+typeoffset_local; + + for (int icoeff = 0; icoeff < ncoeff; icoeff++) { + + snadi[icoeff] += snaptr->dblist[icoeff][0]; + snadi[icoeff+yoffset] += snaptr->dblist[icoeff][1]; + snadi[icoeff+zoffset] += snaptr->dblist[icoeff][2]; + + snadj[icoeff] -= snaptr->dblist[icoeff][0]; + snadj[icoeff+yoffset] -= snaptr->dblist[icoeff][1]; + snadj[icoeff+zoffset] -= snaptr->dblist[icoeff][2]; + } + + if (quadraticflag) { + const int quadraticoffset = ncoeff; + snadi += quadraticoffset; + snadj += quadraticoffset; + int ncount = 0; + for (int icoeff = 0; icoeff < ncoeff; icoeff++) { + double bi = snaptr->blist[icoeff]; + double bix = snaptr->dblist[icoeff][0]; + double biy = snaptr->dblist[icoeff][1]; + double biz = snaptr->dblist[icoeff][2]; + + // diagonal elements of quadratic matrix + + double dbxtmp = bi*bix; + double dbytmp = bi*biy; + double dbztmp = bi*biz; + + snadi[ncount] += dbxtmp; + snadi[ncount+yoffset] += dbytmp; + snadi[ncount+zoffset] += dbztmp; + snadj[ncount] -= dbxtmp; + snadj[ncount+yoffset] -= dbytmp; + snadj[ncount+zoffset] -= dbztmp; + + ncount++; + + // upper-triangular elements of quadratic matrix + + for (int jcoeff = icoeff+1; jcoeff < ncoeff; jcoeff++) { + double dbxtmp = bi*snaptr->dblist[jcoeff][0] + + bix*snaptr->blist[jcoeff]; + double dbytmp = bi*snaptr->dblist[jcoeff][1] + + biy*snaptr->blist[jcoeff]; + double dbztmp = bi*snaptr->dblist[jcoeff][2] + + biz*snaptr->blist[jcoeff]; + + snadi[ncount] += dbxtmp; + snadi[ncount+yoffset] += dbytmp; + snadi[ncount+zoffset] += dbztmp; + snadj[ncount] -= dbxtmp; + snadj[ncount+yoffset] -= dbytmp; + snadj[ncount+zoffset] -= dbztmp; + + ncount++; + } + } + } + } else { + + for (int icoeff = 0; icoeff < ncoeff; icoeff++) { + + // add to snap array for this proc + + // dBi/dRj + + snap[bik_rows + ((atom->tag[j]-1)*3*natoms) + 3*(atom->tag[i]-1) + 0][icoeff+3] -= snaptr->dblist[icoeff][0]; + snap[bik_rows + ((atom->tag[j]-1)*3*natoms) + 3*(atom->tag[i]-1) + 1][icoeff+3] -= snaptr->dblist[icoeff][1]; + snap[bik_rows + ((atom->tag[j]-1)*3*natoms) + 3*(atom->tag[i]-1) + 2][icoeff+3] -= snaptr->dblist[icoeff][2]; + + // dBi/dRi + + snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 0][icoeff+3] += snaptr->dblist[icoeff][0]; + snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 1][icoeff+3] += snaptr->dblist[icoeff][1]; + snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 2][icoeff+3] += snaptr->dblist[icoeff][2]; + } + + } + + } // loop over jj inside + + // accumulate Bi + + if (!dgradflag) { + + // linear contributions + + int k = typeoffset_global; + for (int icoeff = 0; icoeff < ncoeff; icoeff++) + snap[irow][k++] += snaptr->blist[icoeff]; + + // quadratic contributions + + if (quadraticflag) { + for (int icoeff = 0; icoeff < ncoeff; icoeff++) { + double bveci = snaptr->blist[icoeff]; + snap[irow][k++] += 0.5*bveci*bveci; + for (int jcoeff = icoeff+1; jcoeff < ncoeff; jcoeff++) { + double bvecj = snaptr->blist[jcoeff]; + snap[irow][k++] += bveci*bvecj; + } + } + } + + } else { + int k = 3; + for (int icoeff = 0; icoeff < ncoeff; icoeff++) + snap[irow][k++] += snaptr->blist[icoeff]; + numneigh_sum += ninside; + } + + } // if (mask[i] & groupbit) + + } // for (int ii = 0; ii < inum; ii++) { + + // accumulate bispectrum force contributions to global array + + if (!dgradflag) { + + for (int itype = 0; itype < atom->ntypes; itype++) { + const int typeoffset_local = ndims_peratom*nvalues*itype; + const int typeoffset_global = nvalues*itype; + for (int icoeff = 0; icoeff < nvalues; icoeff++) { + for (int i = 0; i < ntotal; i++) { + double *snadi = snap_peratom[i]+typeoffset_local; + int iglobal = atom->tag[i]; + int irow = 3*(iglobal-1)+bik_rows; + snap[irow++][icoeff+typeoffset_global] += snadi[icoeff]; + snap[irow++][icoeff+typeoffset_global] += snadi[icoeff+yoffset]; + snap[irow][icoeff+typeoffset_global] += snadi[icoeff+zoffset]; + } + } + } + + } + + // accumulate forces to global array + + if (!dgradflag) { + for (int i = 0; i < atom->nlocal; i++) { + int iglobal = atom->tag[i]; + int irow = 3*(iglobal-1)+bik_rows; + snap[irow++][lastcol] = atom->f[i][0]; + snap[irow++][lastcol] = atom->f[i][1]; + snap[irow][lastcol] = atom->f[i][2]; + } + + } else { + + // for dgradflag=1, put forces at first 3 columns of bik rows + + for (int i=0; inlocal; i++){ + int iglobal = atom->tag[i]; + snap[iglobal-1][0+0] = atom->f[i][0]; + snap[iglobal-1][0+1] = atom->f[i][1]; + snap[iglobal-1][0+2] = atom->f[i][2]; + } + } + + // accumulate bispectrum virial contributions to global array + + dbdotr_compute(); + + // sum up over all processes + + MPI_Allreduce(&snap[0][0],&snapall[0][0],size_array_rows*size_array_cols,MPI_DOUBLE,MPI_SUM,world); + + // assign energy to last column + + if (!dgradflag) { + for (int i = 0; i < bik_rows; i++) snapall[i][lastcol] = 0; + int irow = 0; + double reference_energy = c_pe->compute_scalar(); + snapall[irow][lastcol] = reference_energy; + + } else { + + // assign reference energy right after the dgrad rows, first column + + int irow = bik_rows + 3*natoms*natoms; + double reference_energy = c_pe->compute_scalar(); + snapall[irow][0] = reference_energy; + } + + // assign virial stress to last column + // switch to Voigt notation + + if (!dgradflag) { + c_virial->compute_vector(); + int irow = 3*natoms+bik_rows; + snapall[irow++][lastcol] = c_virial->vector[0]; + snapall[irow++][lastcol] = c_virial->vector[1]; + snapall[irow++][lastcol] = c_virial->vector[2]; + snapall[irow++][lastcol] = c_virial->vector[5]; + snapall[irow++][lastcol] = c_virial->vector[4]; + snapall[irow][lastcol] = c_virial->vector[3]; + } + +} + +/* ---------------------------------------------------------------------- + compute global virial contributions via summing r_i.dB^j/dr_i over + own & ghost atoms +------------------------------------------------------------------------- */ + +void ComputeSnap::dbdotr_compute() +{ + + // no virial terms for dgrad yet + + if (dgradflag) return; + + double **x = atom->x; + + int irow0 = bik_rows+ndims_force*natoms; + + // sum over bispectrum contributions to forces + // on all particles including ghosts + + int nall = atom->nlocal + atom->nghost; + for (int i = 0; i < nall; i++) + for (int itype = 0; itype < atom->ntypes; itype++) { + const int typeoffset_local = ndims_peratom*nvalues*itype; + const int typeoffset_global = nvalues*itype; + double *snadi = snap_peratom[i]+typeoffset_local; + for (int icoeff = 0; icoeff < nvalues; icoeff++) { + double dbdx = snadi[icoeff]; + double dbdy = snadi[icoeff+yoffset]; + double dbdz = snadi[icoeff+zoffset]; + int irow = irow0; + snap[irow++][icoeff+typeoffset_global] += dbdx*x[i][0]; + snap[irow++][icoeff+typeoffset_global] += dbdy*x[i][1]; + snap[irow++][icoeff+typeoffset_global] += dbdz*x[i][2]; + snap[irow++][icoeff+typeoffset_global] += dbdz*x[i][1]; + snap[irow++][icoeff+typeoffset_global] += dbdz*x[i][0]; + snap[irow][icoeff+typeoffset_global] += dbdy*x[i][0]; + } + } +} + +/* ---------------------------------------------------------------------- + memory usage +------------------------------------------------------------------------- */ + +double ComputeSnap::memory_usage() +{ + + double bytes = (double)size_array_rows*size_array_cols * + sizeof(double); // snap + bytes += (double)size_array_rows*size_array_cols * + sizeof(double); // snapall + bytes += (double)nmax*size_peratom * sizeof(double); // snap_peratom + bytes += snaptr->memory_usage(); // SNA object + int n = atom->ntypes+1; + bytes += (double)n*sizeof(int); // map + + return bytes; +} From 79620c5303b0259ca5bf15efe106fe47d3db96de Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Thu, 7 Jul 2022 13:53:46 -0600 Subject: [PATCH 543/585] Whitespace --- src/ML-SNAP/compute_snap.cpp | 162 +++++++++++++++++------------------ 1 file changed, 81 insertions(+), 81 deletions(-) diff --git a/src/ML-SNAP/compute_snap.cpp b/src/ML-SNAP/compute_snap.cpp index dca3fd3c01..4c30aa4caa 100644 --- a/src/ML-SNAP/compute_snap.cpp +++ b/src/ML-SNAP/compute_snap.cpp @@ -455,89 +455,89 @@ void ComputeSnap::compute_array() // accumulate dBi/dRi, -dBi/dRj - if (!dgradflag) { + if (!dgradflag) { - double *snadi = snap_peratom[i]+typeoffset_local; - double *snadj = snap_peratom[j]+typeoffset_local; + double *snadi = snap_peratom[i]+typeoffset_local; + double *snadj = snap_peratom[j]+typeoffset_local; - for (int icoeff = 0; icoeff < ncoeff; icoeff++) { + for (int icoeff = 0; icoeff < ncoeff; icoeff++) { - snadi[icoeff] += snaptr->dblist[icoeff][0]; - snadi[icoeff+yoffset] += snaptr->dblist[icoeff][1]; - snadi[icoeff+zoffset] += snaptr->dblist[icoeff][2]; + snadi[icoeff] += snaptr->dblist[icoeff][0]; + snadi[icoeff+yoffset] += snaptr->dblist[icoeff][1]; + snadi[icoeff+zoffset] += snaptr->dblist[icoeff][2]; - snadj[icoeff] -= snaptr->dblist[icoeff][0]; - snadj[icoeff+yoffset] -= snaptr->dblist[icoeff][1]; - snadj[icoeff+zoffset] -= snaptr->dblist[icoeff][2]; - } + snadj[icoeff] -= snaptr->dblist[icoeff][0]; + snadj[icoeff+yoffset] -= snaptr->dblist[icoeff][1]; + snadj[icoeff+zoffset] -= snaptr->dblist[icoeff][2]; + } - if (quadraticflag) { - const int quadraticoffset = ncoeff; - snadi += quadraticoffset; - snadj += quadraticoffset; - int ncount = 0; - for (int icoeff = 0; icoeff < ncoeff; icoeff++) { - double bi = snaptr->blist[icoeff]; - double bix = snaptr->dblist[icoeff][0]; - double biy = snaptr->dblist[icoeff][1]; - double biz = snaptr->dblist[icoeff][2]; + if (quadraticflag) { + const int quadraticoffset = ncoeff; + snadi += quadraticoffset; + snadj += quadraticoffset; + int ncount = 0; + for (int icoeff = 0; icoeff < ncoeff; icoeff++) { + double bi = snaptr->blist[icoeff]; + double bix = snaptr->dblist[icoeff][0]; + double biy = snaptr->dblist[icoeff][1]; + double biz = snaptr->dblist[icoeff][2]; - // diagonal elements of quadratic matrix + // diagonal elements of quadratic matrix - double dbxtmp = bi*bix; - double dbytmp = bi*biy; - double dbztmp = bi*biz; + double dbxtmp = bi*bix; + double dbytmp = bi*biy; + double dbztmp = bi*biz; - snadi[ncount] += dbxtmp; - snadi[ncount+yoffset] += dbytmp; - snadi[ncount+zoffset] += dbztmp; - snadj[ncount] -= dbxtmp; - snadj[ncount+yoffset] -= dbytmp; - snadj[ncount+zoffset] -= dbztmp; + snadi[ncount] += dbxtmp; + snadi[ncount+yoffset] += dbytmp; + snadi[ncount+zoffset] += dbztmp; + snadj[ncount] -= dbxtmp; + snadj[ncount+yoffset] -= dbytmp; + snadj[ncount+zoffset] -= dbztmp; - ncount++; + ncount++; - // upper-triangular elements of quadratic matrix + // upper-triangular elements of quadratic matrix - for (int jcoeff = icoeff+1; jcoeff < ncoeff; jcoeff++) { - double dbxtmp = bi*snaptr->dblist[jcoeff][0] - + bix*snaptr->blist[jcoeff]; - double dbytmp = bi*snaptr->dblist[jcoeff][1] - + biy*snaptr->blist[jcoeff]; - double dbztmp = bi*snaptr->dblist[jcoeff][2] - + biz*snaptr->blist[jcoeff]; + for (int jcoeff = icoeff+1; jcoeff < ncoeff; jcoeff++) { + double dbxtmp = bi*snaptr->dblist[jcoeff][0] + + bix*snaptr->blist[jcoeff]; + double dbytmp = bi*snaptr->dblist[jcoeff][1] + + biy*snaptr->blist[jcoeff]; + double dbztmp = bi*snaptr->dblist[jcoeff][2] + + biz*snaptr->blist[jcoeff]; - snadi[ncount] += dbxtmp; - snadi[ncount+yoffset] += dbytmp; - snadi[ncount+zoffset] += dbztmp; - snadj[ncount] -= dbxtmp; - snadj[ncount+yoffset] -= dbytmp; - snadj[ncount+zoffset] -= dbztmp; + snadi[ncount] += dbxtmp; + snadi[ncount+yoffset] += dbytmp; + snadi[ncount+zoffset] += dbztmp; + snadj[ncount] -= dbxtmp; + snadj[ncount+yoffset] -= dbytmp; + snadj[ncount+zoffset] -= dbztmp; - ncount++; - } - } - } - } else { + ncount++; + } + } + } + } else { - for (int icoeff = 0; icoeff < ncoeff; icoeff++) { + for (int icoeff = 0; icoeff < ncoeff; icoeff++) { - // add to snap array for this proc + // add to snap array for this proc - // dBi/dRj + // dBi/dRj - snap[bik_rows + ((atom->tag[j]-1)*3*natoms) + 3*(atom->tag[i]-1) + 0][icoeff+3] -= snaptr->dblist[icoeff][0]; - snap[bik_rows + ((atom->tag[j]-1)*3*natoms) + 3*(atom->tag[i]-1) + 1][icoeff+3] -= snaptr->dblist[icoeff][1]; - snap[bik_rows + ((atom->tag[j]-1)*3*natoms) + 3*(atom->tag[i]-1) + 2][icoeff+3] -= snaptr->dblist[icoeff][2]; + snap[bik_rows + ((atom->tag[j]-1)*3*natoms) + 3*(atom->tag[i]-1) + 0][icoeff+3] -= snaptr->dblist[icoeff][0]; + snap[bik_rows + ((atom->tag[j]-1)*3*natoms) + 3*(atom->tag[i]-1) + 1][icoeff+3] -= snaptr->dblist[icoeff][1]; + snap[bik_rows + ((atom->tag[j]-1)*3*natoms) + 3*(atom->tag[i]-1) + 2][icoeff+3] -= snaptr->dblist[icoeff][2]; - // dBi/dRi + // dBi/dRi - snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 0][icoeff+3] += snaptr->dblist[icoeff][0]; - snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 1][icoeff+3] += snaptr->dblist[icoeff][1]; - snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 2][icoeff+3] += snaptr->dblist[icoeff][2]; - } + snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 0][icoeff+3] += snaptr->dblist[icoeff][0]; + snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 1][icoeff+3] += snaptr->dblist[icoeff][1]; + snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 2][icoeff+3] += snaptr->dblist[icoeff][2]; + } - } + } } // loop over jj inside @@ -545,31 +545,31 @@ void ComputeSnap::compute_array() if (!dgradflag) { - // linear contributions + // linear contributions - int k = typeoffset_global; + int k = typeoffset_global; for (int icoeff = 0; icoeff < ncoeff; icoeff++) snap[irow][k++] += snaptr->blist[icoeff]; - // quadratic contributions + // quadratic contributions - if (quadraticflag) { - for (int icoeff = 0; icoeff < ncoeff; icoeff++) { - double bveci = snaptr->blist[icoeff]; - snap[irow][k++] += 0.5*bveci*bveci; - for (int jcoeff = icoeff+1; jcoeff < ncoeff; jcoeff++) { - double bvecj = snaptr->blist[jcoeff]; - snap[irow][k++] += bveci*bvecj; - } - } - } + if (quadraticflag) { + for (int icoeff = 0; icoeff < ncoeff; icoeff++) { + double bveci = snaptr->blist[icoeff]; + snap[irow][k++] += 0.5*bveci*bveci; + for (int jcoeff = icoeff+1; jcoeff < ncoeff; jcoeff++) { + double bvecj = snaptr->blist[jcoeff]; + snap[irow][k++] += bveci*bvecj; + } + } + } } else { - int k = 3; - for (int icoeff = 0; icoeff < ncoeff; icoeff++) - snap[irow][k++] += snaptr->blist[icoeff]; - numneigh_sum += ninside; - } + int k = 3; + for (int icoeff = 0; icoeff < ncoeff; icoeff++) + snap[irow][k++] += snaptr->blist[icoeff]; + numneigh_sum += ninside; + } } // if (mask[i] & groupbit) From 6100e1fafb1fb3093cc775ada4fcfa5bfe95b9ad Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Thu, 7 Jul 2022 14:33:19 -0600 Subject: [PATCH 544/585] code tweaks and update of examples --- examples/amoeba/Test.sh | 34 ---- examples/amoeba/in.ubiquitin | 8 +- examples/amoeba/in.water_box.amoeba | 4 - examples/amoeba/in.water_box.hippo | 8 +- examples/amoeba/in.water_dimer.amoeba | 8 +- examples/amoeba/in.water_dimer.hippo | 8 +- examples/amoeba/in.water_hexamer.amoeba | 8 +- examples/amoeba/in.water_hexamer.hippo | 8 +- .../amoeba/log.5Jul22.water_box.hippo.g++.4 | 150 ------------------ ...uitin.g++.1 => log.7Jul22.ubiquitin.g++.1} | 49 +++--- ...uitin.g++.4 => log.7Jul22.ubiquitin.g++.4} | 51 +++--- ...++.1 => log.7Jul22.water_box.amoeba.g++.1} | 44 +++-- ...++.4 => log.7Jul22.water_box.amoeba.g++.4} | 46 +++--- ...g++.1 => log.7Jul22.water_box.hippo.g++.1} | 79 +++++---- .../amoeba/log.7Jul22.water_box.hippo.g++.4 | 149 +++++++++++++++++ ....1 => log.7Jul22.water_dimer.amoeba.g++.1} | 59 ++++--- ....4 => log.7Jul22.water_dimer.amoeba.g++.4} | 61 ++++--- ...+.1 => log.7Jul22.water_dimer.hippo.g++.1} | 63 ++++---- ...+.4 => log.7Jul22.water_dimer.hippo.g++.4} | 63 ++++---- ... => log.7Jul22.water_hexamer.amoeba.g++.1} | 57 ++++--- ... => log.7Jul22.water_hexamer.amoeba.g++.4} | 59 ++++--- ...1 => log.7Jul22.water_hexamer.hippo.g++.1} | 61 ++++--- ...4 => log.7Jul22.water_hexamer.hippo.g++.4} | 65 ++++---- src/AMOEBA/amoeba_induce.cpp | 3 +- src/AMOEBA/amoeba_utils.cpp | 2 +- src/AMOEBA/fix_amoeba_bitorsion.cpp | 2 +- src/AMOEBA/pair_amoeba.cpp | 12 +- src/CLASS2/bond_class2.cpp | 20 --- src/CLASS2/bond_class2.h | 2 - src/EXTRA-MOLECULE/dihedral_fourier.cpp | 20 --- src/EXTRA-MOLECULE/dihedral_fourier.h | 2 - 31 files changed, 543 insertions(+), 662 deletions(-) delete mode 100755 examples/amoeba/Test.sh delete mode 100644 examples/amoeba/log.5Jul22.water_box.hippo.g++.4 rename examples/amoeba/{log.5Jul22.ubiquitin.g++.1 => log.7Jul22.ubiquitin.g++.1} (74%) rename examples/amoeba/{log.5Jul22.ubiquitin.g++.4 => log.7Jul22.ubiquitin.g++.4} (73%) rename examples/amoeba/{log.5Jul22.water_box.amoeba.g++.1 => log.7Jul22.water_box.amoeba.g++.1} (85%) rename examples/amoeba/{log.5Jul22.water_box.amoeba.g++.4 => log.7Jul22.water_box.amoeba.g++.4} (84%) rename examples/amoeba/{log.5Jul22.water_box.hippo.g++.1 => log.7Jul22.water_box.hippo.g++.1} (50%) create mode 100644 examples/amoeba/log.7Jul22.water_box.hippo.g++.4 rename examples/amoeba/{log.5Jul22.water_dimer.amoeba.g++.1 => log.7Jul22.water_dimer.amoeba.g++.1} (55%) rename examples/amoeba/{log.5Jul22.water_dimer.amoeba.g++.4 => log.7Jul22.water_dimer.amoeba.g++.4} (55%) rename examples/amoeba/{log.5Jul22.water_dimer.hippo.g++.1 => log.7Jul22.water_dimer.hippo.g++.1} (55%) rename examples/amoeba/{log.5Jul22.water_dimer.hippo.g++.4 => log.7Jul22.water_dimer.hippo.g++.4} (55%) rename examples/amoeba/{log.5Jul22.water_hexamer.amoeba.g++.1 => log.7Jul22.water_hexamer.amoeba.g++.1} (55%) rename examples/amoeba/{log.5Jul22.water_hexamer.amoeba.g++.4 => log.7Jul22.water_hexamer.amoeba.g++.4} (55%) rename examples/amoeba/{log.5Jul22.water_hexamer.hippo.g++.1 => log.7Jul22.water_hexamer.hippo.g++.1} (55%) rename examples/amoeba/{log.5Jul22.water_hexamer.hippo.g++.4 => log.7Jul22.water_hexamer.hippo.g++.4} (55%) diff --git a/examples/amoeba/Test.sh b/examples/amoeba/Test.sh deleted file mode 100755 index 30912a54f5..0000000000 --- a/examples/amoeba/Test.sh +++ /dev/null @@ -1,34 +0,0 @@ -#!/bin/sh -# run test problems. -EXE=${1-../../src/lmp_mpi} -DATE=$(date +%1d%b%y) - -# dimer - -${EXE} -in in.water_dimer.amoeba -log log.${DATE}.water_dimer.amoeba.g++.1 -mpirun -np 4 ${EXE} -in in.water_dimer.amoeba -log log.${DATE}.water_dimer.amoeba.g++.4 - -${EXE} -in in.water_dimer.hippo -log log.${DATE}.water_dimer.hippo.g++.1 -mpirun -np 4 ${EXE} -in in.water_dimer.hippo -log log.${DATE}.water_dimer.hippo.g++.4 - -# hexamer - -${EXE} -in in.water_hexamer.amoeba -log log.${DATE}.water_hexamer.amoeba.g++.1 -mpirun -np 4 ${EXE} -in in.water_hexamer.amoeba -log log.${DATE}.water_hexamer.amoeba.g++.4 - -${EXE} -in in.water_hexamer.hippo -log log.${DATE}.water_hexamer.hippo.g++.1 -mpirun -np 4 ${EXE} -in in.water_hexamer.hippo -log log.${DATE}.water_hexamer.hippo.g++.4 - -# water box - -${EXE} -in in.water_box.amoeba -log log.${DATE}.water_box.amoeba.g++.1 -mpirun -np 4 ${EXE} -in in.water_box.amoeba -log log.${DATE}.water_box.amoeba.g++.4 - -${EXE} -in in.water_box.hippo -log log.${DATE}.water_box.hippo.g++.1 -mpirun -np 4 ${EXE} -in in.water_box.hippo -log log.${DATE}.water_box.hippo.g++.4 - -# ubiquitin - -${EXE} -in in.ubiquitin -log log.${DATE}.ubiquitin.g++.1 -mpirun -np 4 ${EXE} -in in.ubiquitin -log log.${DATE}.ubiquitin.g++.4 - diff --git a/examples/amoeba/in.ubiquitin b/examples/amoeba/in.ubiquitin index 205a2430ad..21ce73bb25 100644 --- a/examples/amoeba/in.ubiquitin +++ b/examples/amoeba/in.ubiquitin @@ -44,13 +44,9 @@ thermo_style custom step temp epair ebond eangle edihed eimp & #dump 1 all custom 10 dump.ubiquitin id type x y z fx fy fz #dump_modify 1 sort id -# zero step run - -#run 0 - # dynamics fix 1 all nve -thermo 1 -run 5 +thermo 10 +run 100 diff --git a/examples/amoeba/in.water_box.amoeba b/examples/amoeba/in.water_box.amoeba index 9963e8926b..d01368c4b4 100644 --- a/examples/amoeba/in.water_box.amoeba +++ b/examples/amoeba/in.water_box.amoeba @@ -35,10 +35,6 @@ thermo_style custom step temp epair ebond eangle edihed eimp & #dump 1 all custom 10 dump.water_box id type x y z fx fy fz #dump_modify 1 sort id -# zero step run - -#run 0 - # dynamics fix 1 all nve diff --git a/examples/amoeba/in.water_box.hippo b/examples/amoeba/in.water_box.hippo index 07010960a8..85e804068d 100644 --- a/examples/amoeba/in.water_box.hippo +++ b/examples/amoeba/in.water_box.hippo @@ -35,13 +35,9 @@ thermo_style custom step temp epair ebond eangle edihed eimp & #dump 1 all custom 10 dump.water_box id type x y z fx fy fz #dump_modify 1 sort id -# zero step run - -#run 0 - # dynamics fix 1 all nve -thermo 1 -run 5 +thermo 10 +run 100 diff --git a/examples/amoeba/in.water_dimer.amoeba b/examples/amoeba/in.water_dimer.amoeba index fb6a83a305..b48ae9f7a9 100644 --- a/examples/amoeba/in.water_dimer.amoeba +++ b/examples/amoeba/in.water_dimer.amoeba @@ -35,13 +35,9 @@ thermo_style custom step temp epair ebond eangle edihed eimp & #dump 1 all custom 10 dump.water_dimer id type x y z fx fy fz #dump_modify 1 sort id -# zero step run - -#run 0 - # dynamics fix 1 all nve -thermo 1 -run 5 +thermo 10 +run 100 diff --git a/examples/amoeba/in.water_dimer.hippo b/examples/amoeba/in.water_dimer.hippo index 19304c159c..154656049a 100644 --- a/examples/amoeba/in.water_dimer.hippo +++ b/examples/amoeba/in.water_dimer.hippo @@ -35,13 +35,9 @@ thermo_style custom step temp epair ebond eangle edihed eimp & #dump 1 all custom 10 dump.water_dimer id type x y z fx fy fz #dump_modify 1 sort id -# zero step run - -#run 0 - # dynamics fix 1 all nve -thermo 1 -run 5 +thermo 10 +run 100 diff --git a/examples/amoeba/in.water_hexamer.amoeba b/examples/amoeba/in.water_hexamer.amoeba index 7fb857b4b8..91642854ff 100644 --- a/examples/amoeba/in.water_hexamer.amoeba +++ b/examples/amoeba/in.water_hexamer.amoeba @@ -35,13 +35,9 @@ thermo_style custom step temp epair ebond eangle edihed eimp & #dump 1 all custom 10 dump.water_hexamer id type x y z fx fy fz #dump_modify 1 sort id -# zero step run - -#run 0 - # dynamics fix 1 all nve -thermo 1 -run 5 +thermo 10 +run 100 diff --git a/examples/amoeba/in.water_hexamer.hippo b/examples/amoeba/in.water_hexamer.hippo index 2de7e3207f..f0d7c0ab97 100644 --- a/examples/amoeba/in.water_hexamer.hippo +++ b/examples/amoeba/in.water_hexamer.hippo @@ -35,13 +35,9 @@ thermo_style custom step temp epair ebond eangle edihed eimp & #dump 1 all custom 10 dump.water_hexamer id type x y z fx fy fz #dump_modify 1 sort id -# zero step run - -#run 0 - # dynamics fix 1 all nve -thermo 1 -run 5 +thermo 10 +run 100 diff --git a/examples/amoeba/log.5Jul22.water_box.hippo.g++.4 b/examples/amoeba/log.5Jul22.water_box.hippo.g++.4 deleted file mode 100644 index 80730c0301..0000000000 --- a/examples/amoeba/log.5Jul22.water_box.hippo.g++.4 +++ /dev/null @@ -1,150 +0,0 @@ -LAMMPS (23 Jun 2022) -OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (src/comm.cpp:98) - using 1 OpenMP thread(s) per MPI task -# water box with AMOEBA or HIPPO - -units real -boundary p p p - -atom_style amoeba -bond_style class2 -angle_style amoeba -dihedral_style none - -# per-atom properties required by AMOEBA or HIPPO - -fix amtype all property/atom i_amtype ghost yes -fix extra all property/atom i_amgroup d_redID d_pval ghost yes -fix extra2 all property/atom i_polaxe d2_xyzaxis 3 - -# read data file - -read_data data.water_box.hippo fix amtype NULL "Tinker Types" -Reading data file ... - orthogonal box = (0 0 0) to (18.643 18.643 18.643) - 1 by 2 by 2 MPI processor grid - reading atoms ... - 648 atoms - scanning bonds ... - 2 = max bonds/atom - scanning angles ... - 1 = max angles/atom - reading bonds ... - 432 bonds - reading angles ... - 216 angles -Finding 1-2 1-3 1-4 neighbors ... - special bond factors lj: 0 0 0 - special bond factors coul: 0 0 0 - 2 = max # of 1-2 neighbors - 1 = max # of 1-3 neighbors - 1 = max # of 1-4 neighbors - 2 = max # of special neighbors - special bonds CPU = 0.000 seconds - read_data CPU = 0.007 seconds - -# force field - -pair_style hippo -pair_coeff * * hippo_water.prm hippo_water_box.key -Reading potential file hippo_water.prm with DATE: 2022-07-05 - -special_bonds lj/coul 0.5 0.5 0.5 one/five yes -Finding 1-2 1-3 1-4 neighbors ... - special bond factors lj: 0.5 0.5 0.5 - special bond factors coul: 0.5 0.5 0.5 - 2 = max # of 1-2 neighbors - 1 = max # of 1-3 neighbors - 1 = max # of 1-4 neighbors - 2 = max # of 1-5 neighbors - 2 = max # of special neighbors - special bonds CPU = 0.000 seconds - -# thermo output - -compute virial all pressure NULL virial - -thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] - -#dump 1 all custom 10 dump.water_box id type x y z fx fy fz -#dump_modify 1 sort id - -# zero step run - -#run 0 - -# dynamics - -fix 1 all nve - -thermo 1 -run 5 -HIPPO force field settings - repulsion: cut 7 taper 6 rscale 0 0 1 1 - qxfer: cut 7 taper 6 mscale 0 0 0.4 1 - dispersion: cut 7 aewald 0.45 bsorder 4 FFT 16 16 16 dspscale 0 0 0.4 1 - multipole: cut 7 aewald 0.4 bsorder 5 FFT 24 24 24 mscale 0 0 0.4 1 - polar: cut 7 aewald 0.5 bsorder 5 FFT 24 24 24 - pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 0.2 1 1 1 d/u scale 0 1 - precondition: cut 4.5 -Generated 0 of 1 mixed pair_coeff terms from geometric mixing rule -Neighbor list info ... - update every 1 steps, delay 10 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 9 - ghost atom cutoff = 9 - binsize = 4.5, bins = 5 5 5 - 1 neighbor lists, perpetual/occasional/extra = 1 0 0 - (1) pair hippo, perpetual - attributes: half, newton on - pair build: half/bin/newton - stencil: half/bin/3d - bin: standard - HIPPO group count: 216 -Per MPI rank memory allocation (min/avg/max) = 55.94 | 55.94 | 55.94 Mbytes - Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] - 0 0 -2188.594 166.82637 77.478353 0 0 244.30473 -1944.2893 -10859.589 -9285.4645 -11598.049 -11695.254 -282.7072 3164.4148 2495.2578 - 1 29.599499 -2189.0009 110.80903 70.640769 0 0 181.4498 -1950.466 -9781.8027 -8491.8338 -11237.523 -10824.225 -316.85579 2724.3099 2103.706 - 2 77.782401 -2189.0806 26.465487 53.091297 0 0 79.556784 -1959.5139 -5674.5913 -4709.6895 -8454.6227 -7034.3366 -270.02397 1600.8009 1104.5782 - 3 83.751912 -2189.1561 36.936027 32.349803 0 0 69.285831 -1958.3477 1505.3642 2789.4989 -1919.6532 227.71216 3.4467207 240.18575 -91.250567 - 4 59.186129 -2195.3882 116.40559 17.314099 0 0 133.71969 -1947.5231 7666.6109 9441.7634 4355.1915 6787.0543 329.33631 -768.83277 -966.66638 - 5 70.911532 -2215.1422 115.71443 14.75745 0 0 130.47188 -1947.9114 7292.9034 8506.6309 4019.0295 6458.6256 348.80878 -911.32703 -1060.6123 -Loop time of 0.122 on 4 procs for 5 steps with 648 atoms - -Performance: 3.541 ns/day, 6.778 hours/ns, 40.984 timesteps/s -98.6% CPU use with 4 MPI tasks x 1 OpenMP threads - -HIPPO timing breakdown: - Init time: 0.000810221 0.67% - Repulse time: 0.0125366 10.36% - Disp time: 0.00623213 5.15% - Mpole time: 0.0210595 17.40% - Induce time: 0.0506279 41.83% - Polar time: 0.026832 22.17% - Qxfer time: 0.00292863 2.42% - Total time: 0.121027 - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 0.12089 | 0.12109 | 0.12131 | 0.0 | 99.25 -Bond | 4.8642e-05 | 5.2114e-05 | 6.0555e-05 | 0.0 | 0.04 -Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.00035781 | 0.00058015 | 0.00076608 | 0.0 | 0.48 -Output | 0.0001878 | 0.00022879 | 0.00026441 | 0.0 | 0.19 -Modify | 1.7668e-05 | 1.8481e-05 | 1.9751e-05 | 0.0 | 0.02 -Other | | 3.389e-05 | | | 0.03 - -Nlocal: 162 ave 166 max 159 min -Histogram: 2 0 0 0 0 0 0 1 0 1 -Nghost: 2582.75 ave 2600 max 2559 min -Histogram: 1 0 0 1 0 0 0 0 0 2 -Neighs: 24646.2 ave 25106 max 23932 min -Histogram: 1 0 0 0 0 0 1 0 1 1 - -Total # of neighbors = 98585 -Ave neighs/atom = 152.13735 -Ave special neighs/atom = 2 -Neighbor list builds = 0 -Dangerous builds = 0 -Total wall time: 0:00:00 diff --git a/examples/amoeba/log.5Jul22.ubiquitin.g++.1 b/examples/amoeba/log.7Jul22.ubiquitin.g++.1 similarity index 74% rename from examples/amoeba/log.5Jul22.ubiquitin.g++.1 rename to examples/amoeba/log.7Jul22.ubiquitin.g++.1 index 74019ccdf9..8924eb8e70 100644 --- a/examples/amoeba/log.5Jul22.ubiquitin.g++.1 +++ b/examples/amoeba/log.7Jul22.ubiquitin.g++.1 @@ -1,6 +1,4 @@ LAMMPS (23 Jun 2022) -OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (src/comm.cpp:98) - using 1 OpenMP thread(s) per MPI task # solvated ubiquitin molecule with AMOEBA force field units real @@ -56,7 +54,7 @@ Finding 1-2 1-3 1-4 neighbors ... 9 = max # of 1-3 neighbors 19 = max # of 1-4 neighbors 21 = max # of special neighbors - special bonds CPU = 0.003 seconds + special bonds CPU = 0.004 seconds read_data CPU = 0.077 seconds pair_style amoeba @@ -75,7 +73,7 @@ Finding 1-2 1-3 1-4 neighbors ... 19 = max # of 1-4 neighbors 58 = max # of 1-5 neighbors 21 = max # of special neighbors - special bonds CPU = 0.005 seconds + special bonds CPU = 0.006 seconds # thermo output @@ -86,16 +84,12 @@ thermo_style custom step temp epair ebond eangle edihed eimp #dump 1 all custom 10 dump.ubiquitin id type x y z fx fy fz #dump_modify 1 sort id -# zero step run - -#run 0 - # dynamics fix 1 all nve thermo 1 -run 5 +run 10 AMOEBA force field settings hal: cut 12 taper 10.8 vscale 0 0 1 1 multipole: cut 7 aewald 0.4 bsorder 5 FFT 60 48 48 mscale 0 0 0.4 1 @@ -124,29 +118,34 @@ Per MPI rank memory allocation (min/avg/max) = 258.3 | 258.3 | 258.3 Mbytes 3 88.8921 -35402.11 938.99299 1162.2914 220.5271 58.832521 2380.644 -30453.516 -1929.5417 -3331.1291 -2769.7218 -3350.5733 117.32302 279.72705 31.237776 4 68.740402 -35477.589 2048.0659 858.03795 218.14277 54.460022 3178.7066 -30316.325 2041.1138 594.25938 1665.7799 1030.8539 66.230421 304.28296 -155.80224 5 76.267862 -35707.869 2206.6534 736.37385 215.75693 49.401674 3208.1859 -30299.377 2276.9276 536.21124 1893.4621 1258.492 92.097191 299.65604 -228.58369 -Loop time of 6.65546 on 1 procs for 5 steps with 9737 atoms + 6 118.24373 -36092.77 1166.179 815.59206 213.67399 44.022297 2239.4673 -30435.629 -1677.8051 -3988.2428 -2669.6848 -3247.7207 197.42472 285.87129 -162.35459 + 7 137.7204 -36521.444 782.87113 1026.745 212.04289 38.686259 2060.3452 -30479.082 -5987.83 -8386.8104 -7363.188 -7888.261 357.00835 253.66346 32.827786 + 8 112.66452 -36897.181 1750.0569 1269.152 210.83571 33.742799 3263.7874 -30379.432 -7886.4081 -9703.2601 -9043.015 -9555.2908 490.76046 182.31259 278.727 + 9 88.237359 -37209.906 2695.1766 1454.55 209.91331 29.503458 4389.1434 -30276.565 -8202.16 -9492.368 -9110.7037 -9639.2288 502.55699 107.82333 443.6705 + 10 108.86756 -37474.988 2240.4603 1523.7936 209.10313 26.208515 3999.5656 -30333.279 -8468.4347 -9956.923 -9709.5874 -10224.682 365.98214 95.262991 425.12746 +Loop time of 24.1308 on 1 procs for 10 steps with 9737 atoms -Performance: 0.065 ns/day, 369.748 hours/ns, 0.751 timesteps/s -99.8% CPU use with 1 MPI tasks x 1 OpenMP threads +Performance: 0.036 ns/day, 670.300 hours/ns, 0.414 timesteps/s +99.4% CPU use with 1 MPI tasks x no OpenMP threads AMOEBA timing breakdown: - Init time: 0.0105468 0.16% - Hal time: 1.57051 23.62% - Mpole time: 0.805631 12.12% - Induce time: 2.69099 40.48% - Polar time: 1.57015 23.62% - Total time: 6.64783 + Init time: 0.0307243 0.13% + Hal time: 7.7896 32.31% + Mpole time: 2.35085 9.75% + Induce time: 9.19392 38.14% + Polar time: 4.74032 19.66% + Total time: 24.1054 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 6.6478 | 6.6478 | 6.6478 | 0.0 | 99.89 -Bond | 0.0052138 | 0.0052138 | 0.0052138 | 0.0 | 0.08 +Pair | 24.105 | 24.105 | 24.105 | 0.0 | 99.90 +Bond | 0.016307 | 0.016307 | 0.016307 | 0.0 | 0.07 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.0010535 | 0.0010535 | 0.0010535 | 0.0 | 0.02 -Output | 0.00033674 | 0.00033674 | 0.00033674 | 0.0 | 0.01 -Modify | 0.00085639 | 0.00085639 | 0.00085639 | 0.0 | 0.01 -Other | | 0.000145 | | | 0.00 +Comm | 0.0039483 | 0.0039483 | 0.0039483 | 0.0 | 0.02 +Output | 0.001034 | 0.001034 | 0.001034 | 0.0 | 0.00 +Modify | 0.0032551 | 0.0032551 | 0.0032551 | 0.0 | 0.01 +Other | | 0.00076 | | | 0.00 Nlocal: 9737 ave 9737 max 9737 min Histogram: 1 0 0 0 0 0 0 0 0 0 @@ -160,4 +159,4 @@ Ave neighs/atom = 579.16155 Ave special neighs/atom = 3.1364897 Neighbor list builds = 0 Dangerous builds = 0 -Total wall time: 0:00:08 +Total wall time: 0:00:27 diff --git a/examples/amoeba/log.5Jul22.ubiquitin.g++.4 b/examples/amoeba/log.7Jul22.ubiquitin.g++.4 similarity index 73% rename from examples/amoeba/log.5Jul22.ubiquitin.g++.4 rename to examples/amoeba/log.7Jul22.ubiquitin.g++.4 index fed3f9896e..cc9acfe1aa 100644 --- a/examples/amoeba/log.5Jul22.ubiquitin.g++.4 +++ b/examples/amoeba/log.7Jul22.ubiquitin.g++.4 @@ -1,6 +1,4 @@ LAMMPS (23 Jun 2022) -OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (src/comm.cpp:98) - using 1 OpenMP thread(s) per MPI task # solvated ubiquitin molecule with AMOEBA force field units real @@ -56,8 +54,8 @@ Finding 1-2 1-3 1-4 neighbors ... 9 = max # of 1-3 neighbors 19 = max # of 1-4 neighbors 21 = max # of special neighbors - special bonds CPU = 0.001 seconds - read_data CPU = 0.036 seconds + special bonds CPU = 0.002 seconds + read_data CPU = 0.100 seconds pair_style amoeba pair_coeff * * amoeba_ubiquitin.prm amoeba_ubiquitin.key @@ -75,7 +73,7 @@ Finding 1-2 1-3 1-4 neighbors ... 19 = max # of 1-4 neighbors 58 = max # of 1-5 neighbors 21 = max # of special neighbors - special bonds CPU = 0.001 seconds + special bonds CPU = 0.002 seconds # thermo output @@ -86,16 +84,12 @@ thermo_style custom step temp epair ebond eangle edihed eimp #dump 1 all custom 10 dump.ubiquitin id type x y z fx fy fz #dump_modify 1 sort id -# zero step run - -#run 0 - # dynamics fix 1 all nve thermo 1 -run 5 +run 10 AMOEBA force field settings hal: cut 12 taper 10.8 vscale 0 0 1 1 multipole: cut 7 aewald 0.4 bsorder 5 FFT 60 48 48 mscale 0 0 0.4 1 @@ -124,29 +118,34 @@ Per MPI rank memory allocation (min/avg/max) = 144.2 | 144.7 | 145.4 Mbytes 3 88.8921 -35402.11 938.99299 1162.2914 220.5271 58.832521 2380.644 -30453.516 -1929.5417 -3331.1291 -2769.7218 -3350.5733 117.32302 279.72705 31.237776 4 68.740402 -35477.589 2048.0659 858.03795 218.14277 54.460022 3178.7066 -30316.325 2041.1138 594.25938 1665.7799 1030.8539 66.230421 304.28296 -155.80224 5 76.267862 -35707.869 2206.6534 736.37385 215.75693 49.401674 3208.1859 -30299.377 2276.9276 536.21124 1893.4621 1258.492 92.097191 299.65604 -228.58369 -Loop time of 2.1516 on 4 procs for 5 steps with 9737 atoms + 6 118.24373 -36092.77 1166.179 815.59206 213.67399 44.022297 2239.4673 -30435.629 -1677.8051 -3988.2428 -2669.6848 -3247.7207 197.42472 285.87129 -162.35459 + 7 137.7204 -36521.444 782.87113 1026.745 212.04289 38.686259 2060.3452 -30479.082 -5987.83 -8386.8104 -7363.188 -7888.261 357.00835 253.66346 32.827786 + 8 112.66452 -36897.181 1750.0569 1269.152 210.83571 33.742799 3263.7874 -30379.432 -7886.4081 -9703.2601 -9043.015 -9555.2908 490.76046 182.31259 278.727 + 9 88.237359 -37209.906 2695.1766 1454.55 209.91331 29.503458 4389.1434 -30276.565 -8202.16 -9492.368 -9110.7037 -9639.2288 502.55699 107.82333 443.6705 + 10 108.86756 -37474.988 2240.4603 1523.7936 209.10313 26.208515 3999.5656 -30333.279 -8468.4347 -9956.923 -9709.5874 -10224.682 365.98214 95.262991 425.12746 +Loop time of 6.07676 on 4 procs for 10 steps with 9737 atoms -Performance: 0.201 ns/day, 119.533 hours/ns, 2.324 timesteps/s -99.4% CPU use with 4 MPI tasks x 1 OpenMP threads +Performance: 0.142 ns/day, 168.799 hours/ns, 1.646 timesteps/s +99.6% CPU use with 4 MPI tasks x no OpenMP threads AMOEBA timing breakdown: - Init time: 0.0116891 0.54% - Hal time: 0.423411 19.72% - Mpole time: 0.269917 12.57% - Induce time: 0.929983 43.30% - Polar time: 0.512586 23.87% - Total time: 2.14759 + Init time: 0.0182673 0.30% + Hal time: 1.89506 31.24% + Mpole time: 0.649816 10.71% + Induce time: 2.27346 37.48% + Polar time: 1.22947 20.27% + Total time: 6.06608 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 2.1477 | 2.1477 | 2.1477 | 0.0 | 99.82 -Bond | 0.001184 | 0.0014529 | 0.0016771 | 0.5 | 0.07 +Pair | 6.0656 | 6.0662 | 6.067 | 0.0 | 99.83 +Bond | 0.0030706 | 0.0035014 | 0.0039085 | 0.5 | 0.06 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.0015356 | 0.0017027 | 0.001922 | 0.4 | 0.08 -Output | 0.00027025 | 0.0003219 | 0.00040484 | 0.0 | 0.01 -Modify | 0.00028633 | 0.00030716 | 0.00032386 | 0.0 | 0.01 -Other | | 0.0001328 | | | 0.01 +Comm | 0.0045136 | 0.0052483 | 0.0058373 | 0.7 | 0.09 +Output | 0.00065752 | 0.0007782 | 0.00099256 | 0.0 | 0.01 +Modify | 0.00065468 | 0.0007142 | 0.00077861 | 0.0 | 0.01 +Other | | 0.0003323 | | | 0.01 Nlocal: 2434.25 ave 2498 max 2390 min Histogram: 1 1 0 0 1 0 0 0 0 1 @@ -160,4 +159,4 @@ Ave neighs/atom = 579.16155 Ave special neighs/atom = 3.1364897 Neighbor list builds = 0 Dangerous builds = 0 -Total wall time: 0:00:02 +Total wall time: 0:00:07 diff --git a/examples/amoeba/log.5Jul22.water_box.amoeba.g++.1 b/examples/amoeba/log.7Jul22.water_box.amoeba.g++.1 similarity index 85% rename from examples/amoeba/log.5Jul22.water_box.amoeba.g++.1 rename to examples/amoeba/log.7Jul22.water_box.amoeba.g++.1 index 23b9fee06f..0950951e2a 100644 --- a/examples/amoeba/log.5Jul22.water_box.amoeba.g++.1 +++ b/examples/amoeba/log.7Jul22.water_box.amoeba.g++.1 @@ -1,6 +1,4 @@ LAMMPS (23 Jun 2022) -OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (src/comm.cpp:98) - using 1 OpenMP thread(s) per MPI task # replicate water box with AMOEBA or HIPPO units real @@ -40,8 +38,8 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-3 neighbors 1 = max # of 1-4 neighbors 2 = max # of special neighbors - special bonds CPU = 0.001 seconds - read_data CPU = 0.012 seconds + special bonds CPU = 0.000 seconds + read_data CPU = 0.011 seconds # force field @@ -69,10 +67,6 @@ thermo_style custom step temp epair ebond eangle edihed eimp #dump 1 all custom 10 dump.water_box id type x y z fx fy fz #dump_modify 1 sort id -# zero step run - -#run 0 - # dynamics fix 1 all nve @@ -112,29 +106,29 @@ Per MPI rank memory allocation (min/avg/max) = 56.94 | 56.94 | 56.94 Mbytes 80 171.83506 -2388.0612 76.465932 49.1299 0 0 125.59583 -1931.067 2210.3658 -318.23867 330.74353 -395.26693 -43.142216 252.53012 -1987.0412 90 175.73401 -2423.8154 90.786573 63.719496 0 0 154.50607 -1930.3915 -916.91571 -3942.3954 -2566.5361 -3414.8202 199.82369 2365.9443 -266.38604 100 173.72684 -2422.367 99.75941 57.294464 0 0 157.05387 -1930.2663 -3585.8356 -5734.1341 -5882.0146 -6232.4353 -227.79935 959.68225 404.47924 -Loop time of 9.23157 on 1 procs for 100 steps with 648 atoms +Loop time of 13.2332 on 1 procs for 100 steps with 648 atoms -Performance: 0.936 ns/day, 25.643 hours/ns, 10.832 timesteps/s -99.8% CPU use with 1 MPI tasks x 1 OpenMP threads +Performance: 0.653 ns/day, 36.759 hours/ns, 7.557 timesteps/s +99.8% CPU use with 1 MPI tasks x no OpenMP threads AMOEBA timing breakdown: - Init time: 0.0194993 0.21% - Hal time: 0.383028 4.15% - Mpole time: 0.935775 10.15% - Induce time: 6.06306 65.76% - Polar time: 1.81839 19.72% - Total time: 9.21978 + Init time: 0.020242 0.15% + Hal time: 0.900253 6.81% + Mpole time: 1.29931 9.83% + Induce time: 8.37539 63.35% + Polar time: 2.62525 19.86% + Total time: 13.2205 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 9.2201 | 9.2201 | 9.2201 | 0.0 | 99.88 -Bond | 0.0024949 | 0.0024949 | 0.0024949 | 0.0 | 0.03 -Neigh | 0.0046051 | 0.0046051 | 0.0046051 | 0.0 | 0.05 -Comm | 0.0023611 | 0.0023611 | 0.0023611 | 0.0 | 0.03 -Output | 0.00045516 | 0.00045516 | 0.00045516 | 0.0 | 0.00 -Modify | 0.00070554 | 0.00070554 | 0.00070554 | 0.0 | 0.01 -Other | | 0.0008327 | | | 0.01 +Pair | 13.221 | 13.221 | 13.221 | 0.0 | 99.90 +Bond | 0.0027476 | 0.0027476 | 0.0027476 | 0.0 | 0.02 +Neigh | 0.0055619 | 0.0055619 | 0.0055619 | 0.0 | 0.04 +Comm | 0.002464 | 0.002464 | 0.002464 | 0.0 | 0.02 +Output | 0.00041636 | 0.00041636 | 0.00041636 | 0.0 | 0.00 +Modify | 0.00068882 | 0.00068882 | 0.00068882 | 0.0 | 0.01 +Other | | 0.0007637 | | | 0.01 Nlocal: 648 ave 648 max 648 min Histogram: 1 0 0 0 0 0 0 0 0 0 @@ -148,4 +142,4 @@ Ave neighs/atom = 152.07562 Ave special neighs/atom = 2 Neighbor list builds = 2 Dangerous builds = 0 -Total wall time: 0:00:09 +Total wall time: 0:00:13 diff --git a/examples/amoeba/log.5Jul22.water_box.amoeba.g++.4 b/examples/amoeba/log.7Jul22.water_box.amoeba.g++.4 similarity index 84% rename from examples/amoeba/log.5Jul22.water_box.amoeba.g++.4 rename to examples/amoeba/log.7Jul22.water_box.amoeba.g++.4 index 1db1f9abee..8f0f096317 100644 --- a/examples/amoeba/log.5Jul22.water_box.amoeba.g++.4 +++ b/examples/amoeba/log.7Jul22.water_box.amoeba.g++.4 @@ -1,6 +1,4 @@ LAMMPS (23 Jun 2022) -OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (src/comm.cpp:98) - using 1 OpenMP thread(s) per MPI task # replicate water box with AMOEBA or HIPPO units real @@ -40,8 +38,8 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-3 neighbors 1 = max # of 1-4 neighbors 2 = max # of special neighbors - special bonds CPU = 0.000 seconds - read_data CPU = 0.005 seconds + special bonds CPU = 0.001 seconds + read_data CPU = 0.014 seconds # force field @@ -58,7 +56,7 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of 1-5 neighbors 2 = max # of special neighbors - special bonds CPU = 0.000 seconds + special bonds CPU = 0.001 seconds # thermo output @@ -69,10 +67,6 @@ thermo_style custom step temp epair ebond eangle edihed eimp #dump 1 all custom 10 dump.water_box id type x y z fx fy fz #dump_modify 1 sort id -# zero step run - -#run 0 - # dynamics fix 1 all nve @@ -112,29 +106,29 @@ Per MPI rank memory allocation (min/avg/max) = 56.38 | 56.38 | 56.38 Mbytes 80 171.83506 -2388.0612 76.465932 49.1299 0 0 125.59583 -1931.067 2210.3658 -318.23867 330.74353 -395.26693 -43.142216 252.53012 -1987.0412 90 175.73401 -2423.8154 90.786573 63.719496 0 0 154.50607 -1930.3915 -916.91571 -3942.3954 -2566.5361 -3414.8202 199.82369 2365.9443 -266.38604 100 173.72684 -2422.367 99.75941 57.294464 0 0 157.05387 -1930.2663 -3585.8356 -5734.1341 -5882.0146 -6232.4353 -227.79935 959.68225 404.47924 -Loop time of 3.62992 on 4 procs for 100 steps with 648 atoms +Loop time of 5.51861 on 4 procs for 100 steps with 648 atoms -Performance: 2.380 ns/day, 10.083 hours/ns, 27.549 timesteps/s -99.3% CPU use with 4 MPI tasks x 1 OpenMP threads +Performance: 1.566 ns/day, 15.329 hours/ns, 18.120 timesteps/s +100.0% CPU use with 4 MPI tasks x no OpenMP threads AMOEBA timing breakdown: - Init time: 0.0211291 0.58% - Hal time: 0.114718 3.17% - Mpole time: 0.329891 9.11% - Induce time: 2.5339 69.99% - Polar time: 0.620639 17.14% - Total time: 3.6203 + Init time: 0.0236604 0.43% + Hal time: 0.257977 4.69% + Mpole time: 0.530078 9.63% + Induce time: 3.72129 67.60% + Polar time: 0.972013 17.66% + Total time: 5.50503 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 3.6209 | 3.621 | 3.6211 | 0.0 | 99.75 -Bond | 0.00085544 | 0.00087038 | 0.00090469 | 0.0 | 0.02 -Neigh | 0.0014354 | 0.0014405 | 0.0014453 | 0.0 | 0.04 -Comm | 0.004823 | 0.0048746 | 0.0049092 | 0.0 | 0.13 -Output | 0.00038727 | 0.00043628 | 0.00055233 | 0.0 | 0.01 -Modify | 0.00033814 | 0.0003491 | 0.00037267 | 0.0 | 0.01 -Other | | 0.0009691 | | | 0.03 +Pair | 5.5047 | 5.5054 | 5.5063 | 0.0 | 99.76 +Bond | 0.00080214 | 0.00087764 | 0.00092311 | 0.0 | 0.02 +Neigh | 0.0016691 | 0.001675 | 0.0016849 | 0.0 | 0.03 +Comm | 0.0083938 | 0.0092735 | 0.010026 | 0.7 | 0.17 +Output | 0.000358 | 0.00041667 | 0.00056168 | 0.0 | 0.01 +Modify | 0.00022011 | 0.00024519 | 0.00025818 | 0.0 | 0.00 +Other | | 0.0007611 | | | 0.01 Nlocal: 162 ave 164 max 159 min Histogram: 1 0 0 0 0 0 1 0 1 1 @@ -148,4 +142,4 @@ Ave neighs/atom = 152.07562 Ave special neighs/atom = 2 Neighbor list builds = 2 Dangerous builds = 0 -Total wall time: 0:00:03 +Total wall time: 0:00:05 diff --git a/examples/amoeba/log.5Jul22.water_box.hippo.g++.1 b/examples/amoeba/log.7Jul22.water_box.hippo.g++.1 similarity index 50% rename from examples/amoeba/log.5Jul22.water_box.hippo.g++.1 rename to examples/amoeba/log.7Jul22.water_box.hippo.g++.1 index 1c998687f4..32ba65389f 100644 --- a/examples/amoeba/log.5Jul22.water_box.hippo.g++.1 +++ b/examples/amoeba/log.7Jul22.water_box.hippo.g++.1 @@ -1,6 +1,4 @@ LAMMPS (23 Jun 2022) -OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (src/comm.cpp:98) - using 1 OpenMP thread(s) per MPI task # water box with AMOEBA or HIPPO units real @@ -40,8 +38,8 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-3 neighbors 1 = max # of 1-4 neighbors 2 = max # of special neighbors - special bonds CPU = 0.000 seconds - read_data CPU = 0.004 seconds + special bonds CPU = 0.001 seconds + read_data CPU = 0.012 seconds # force field @@ -58,7 +56,7 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of 1-5 neighbors 2 = max # of special neighbors - special bonds CPU = 0.000 seconds + special bonds CPU = 0.001 seconds # thermo output @@ -69,16 +67,12 @@ thermo_style custom step temp epair ebond eangle edihed eimp #dump 1 all custom 10 dump.water_box id type x y z fx fy fz #dump_modify 1 sort id -# zero step run - -#run 0 - # dynamics fix 1 all nve -thermo 1 -run 5 +thermo 10 +run 100 HIPPO force field settings repulsion: cut 7 taper 6 rscale 0 0 1 1 qxfer: cut 7 taper 6 mscale 0 0 0.4 1 @@ -104,47 +98,52 @@ Neighbor list info ... Per MPI rank memory allocation (min/avg/max) = 56.46 | 56.46 | 56.46 Mbytes Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] 0 0 -2188.594 166.82637 77.478353 0 0 244.30473 -1944.2893 -10859.589 -9285.4645 -11598.049 -11695.254 -282.7072 3164.4148 2495.2578 - 1 29.599499 -2189.0009 110.80903 70.640769 0 0 181.4498 -1950.466 -9781.8027 -8491.8338 -11237.523 -10824.225 -316.85579 2724.3099 2103.706 - 2 77.782401 -2189.0806 26.465487 53.091297 0 0 79.556784 -1959.5139 -5674.5913 -4709.6895 -8454.6227 -7034.3366 -270.02397 1600.8009 1104.5782 - 3 83.751912 -2189.1561 36.936027 32.349803 0 0 69.285831 -1958.3477 1505.3642 2789.4989 -1919.6532 227.71216 3.4467207 240.18575 -91.250567 - 4 59.186129 -2195.3882 116.40559 17.314099 0 0 133.71969 -1947.5231 7666.6109 9441.7634 4355.1915 6787.0543 329.33631 -768.83277 -966.66638 - 5 70.911532 -2215.1422 115.71443 14.75745 0 0 130.47188 -1947.9114 7292.9034 8506.6309 4019.0295 6458.6256 348.80878 -911.32703 -1060.6123 -Loop time of 0.326218 on 1 procs for 5 steps with 648 atoms + 10 100.94691 -2350.192 116.13156 88.56605 0 0 204.69761 -1950.8098 -11480.919 -13574.139 -12190.797 -12798.212 -263.77028 280.62864 1974.1486 + 20 153.91622 -2358.3058 36.396961 66.22466 0 0 102.62162 -1958.8438 -7778.4529 -8492.3868 -11999.431 -9125.9998 -917.99962 589.09064 1788.2094 + 30 145.5951 -2343.9956 39.651541 65.833248 0 0 105.48479 -1957.7184 -288.79965 -2574.4466 -3820.4824 -414.28285 -347.51491 -1147.3995 -126.71025 + 40 126.87801 -2340.2623 102.93951 43.896946 0 0 146.83646 -1948.7309 6766.15 5908.7048 1280.0961 7930.8191 -1085.6811 -1596.6859 -714.82888 + 50 134.52078 -2358.9232 107.49288 44.253826 0 0 151.74671 -1947.7419 8762.4348 6023.4661 5377.0189 9396.0316 -1629.1364 -1663.1666 -2381.51 + 60 173.10181 -2374.3854 51.097314 33.03646 0 0 84.133774 -1956.4102 4614.2907 1719.1989 505.79149 4552.3167 -1661.1714 -587.92108 -1380.6732 + 70 184.86849 -2391.6106 39.916931 35.978152 0 0 75.895083 -1959.1811 -2146.9339 -4993.4021 -4095.6729 -4897.5768 -833.09046 1542.411 -1539.5266 + 80 164.75795 -2406.3017 101.94229 33.067832 0 0 135.01013 -1953.542 -8779.3265 -10545.409 -10418.702 -12098.858 -1319.194 1750.3511 -275.1272 + 90 151.17491 -2434.6876 152.21826 41.301673 0 0 193.51993 -1949.6141 -13330.691 -15436.505 -13791.461 -16934.674 149.25497 2289.1026 976.14333 + 100 166.99163 -2452.5298 143.57768 35.341459 0 0 178.91914 -1951.5533 -14918.51 -16077.49 -17353.738 -18140.466 19.009088 1487.0469 1084.0231 +Loop time of 10.7228 on 1 procs for 100 steps with 648 atoms -Performance: 1.324 ns/day, 18.123 hours/ns, 15.327 timesteps/s -99.8% CPU use with 1 MPI tasks x 1 OpenMP threads +Performance: 0.806 ns/day, 29.786 hours/ns, 9.326 timesteps/s +99.9% CPU use with 1 MPI tasks x no OpenMP threads HIPPO timing breakdown: - Init time: 0.000842282 0.26% - Repulse time: 0.0383544 11.78% - Disp time: 0.0173558 5.33% - Mpole time: 0.0613861 18.85% - Induce time: 0.121337 37.26% - Polar time: 0.0763061 23.43% - Qxfer time: 0.0101016 3.10% - Total time: 0.325683 + Init time: 0.0153975 0.14% + Repulse time: 1.2388 11.57% + Disp time: 0.693631 6.48% + Mpole time: 2.01598 18.83% + Induce time: 3.8747 36.19% + Polar time: 2.52726 23.60% + Qxfer time: 0.341839 3.19% + Total time: 10.7076 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.3257 | 0.3257 | 0.3257 | 0.0 | 99.84 -Bond | 0.00013737 | 0.00013737 | 0.00013737 | 0.0 | 0.04 -Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.0001122 | 0.0001122 | 0.0001122 | 0.0 | 0.03 -Output | 0.00020981 | 0.00020981 | 0.00020981 | 0.0 | 0.06 -Modify | 3.4058e-05 | 3.4058e-05 | 3.4058e-05 | 0.0 | 0.01 -Other | | 2.595e-05 | | | 0.01 +Pair | 10.708 | 10.708 | 10.708 | 0.0 | 99.86 +Bond | 0.0028607 | 0.0028607 | 0.0028607 | 0.0 | 0.03 +Neigh | 0.0073977 | 0.0073977 | 0.0073977 | 0.0 | 0.07 +Comm | 0.0026424 | 0.0026424 | 0.0026424 | 0.0 | 0.02 +Output | 0.00048358 | 0.00048358 | 0.00048358 | 0.0 | 0.00 +Modify | 0.00077694 | 0.00077694 | 0.00077694 | 0.0 | 0.01 +Other | | 0.0008999 | | | 0.01 Nlocal: 648 ave 648 max 648 min Histogram: 1 0 0 0 0 0 0 0 0 0 -Nghost: 4302 ave 4302 max 4302 min +Nghost: 4282 ave 4282 max 4282 min Histogram: 1 0 0 0 0 0 0 0 0 0 -Neighs: 98585 ave 98585 max 98585 min +Neighs: 98490 ave 98490 max 98490 min Histogram: 1 0 0 0 0 0 0 0 0 0 -Total # of neighbors = 98585 -Ave neighs/atom = 152.13735 +Total # of neighbors = 98490 +Ave neighs/atom = 151.99074 Ave special neighs/atom = 2 -Neighbor list builds = 0 +Neighbor list builds = 2 Dangerous builds = 0 -Total wall time: 0:00:00 +Total wall time: 0:00:10 diff --git a/examples/amoeba/log.7Jul22.water_box.hippo.g++.4 b/examples/amoeba/log.7Jul22.water_box.hippo.g++.4 new file mode 100644 index 0000000000..456d58d23d --- /dev/null +++ b/examples/amoeba/log.7Jul22.water_box.hippo.g++.4 @@ -0,0 +1,149 @@ +LAMMPS (23 Jun 2022) +# water box with AMOEBA or HIPPO + +units real +boundary p p p + +atom_style amoeba +bond_style class2 +angle_style amoeba +dihedral_style none + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 + +# read data file + +read_data data.water_box.hippo fix amtype NULL "Tinker Types" +Reading data file ... + orthogonal box = (0 0 0) to (18.643 18.643 18.643) + 1 by 2 by 2 MPI processor grid + reading atoms ... + 648 atoms + scanning bonds ... + 2 = max bonds/atom + scanning angles ... + 1 = max angles/atom + reading bonds ... + 432 bonds + reading angles ... + 216 angles +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + read_data CPU = 0.012 seconds + +# force field + +pair_style hippo +pair_coeff * * hippo_water.prm hippo_water_box.key +Reading potential file hippo_water.prm with DATE: 2022-07-05 + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0.5 0.5 0.5 + special bond factors coul: 0.5 0.5 0.5 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of 1-5 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.001 seconds + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] + +#dump 1 all custom 10 dump.water_box id type x y z fx fy fz +#dump_modify 1 sort id + +# dynamics + +fix 1 all nve + +thermo 10 +run 100 +HIPPO force field settings + repulsion: cut 7 taper 6 rscale 0 0 1 1 + qxfer: cut 7 taper 6 mscale 0 0 0.4 1 + dispersion: cut 7 aewald 0.45 bsorder 4 FFT 16 16 16 dspscale 0 0 0.4 1 + multipole: cut 7 aewald 0.4 bsorder 5 FFT 24 24 24 mscale 0 0 0.4 1 + polar: cut 7 aewald 0.5 bsorder 5 FFT 24 24 24 + pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 0.2 1 1 1 d/u scale 0 1 + precondition: cut 4.5 +Generated 0 of 1 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 9 + ghost atom cutoff = 9 + binsize = 4.5, bins = 5 5 5 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair hippo, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d + bin: standard + HIPPO group count: 216 +Per MPI rank memory allocation (min/avg/max) = 55.94 | 55.94 | 55.94 Mbytes + Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] + 0 0 -2188.594 166.82637 77.478353 0 0 244.30473 -1944.2893 -10859.589 -9285.4645 -11598.049 -11695.254 -282.7072 3164.4148 2495.2578 + 10 100.94691 -2350.192 116.13156 88.56605 0 0 204.69761 -1950.8098 -11480.919 -13574.139 -12190.797 -12798.212 -263.77028 280.62864 1974.1486 + 20 153.91622 -2358.3058 36.396961 66.22466 0 0 102.62162 -1958.8438 -7778.4529 -8492.3868 -11999.431 -9125.9998 -917.99962 589.09064 1788.2094 + 30 145.5951 -2343.9956 39.651541 65.833248 0 0 105.48479 -1957.7184 -288.79965 -2574.4466 -3820.4824 -414.28285 -347.51491 -1147.3995 -126.71025 + 40 126.87801 -2340.2623 102.93951 43.896946 0 0 146.83646 -1948.7309 6766.15 5908.7048 1280.0961 7930.8191 -1085.6811 -1596.6859 -714.82888 + 50 134.52078 -2358.9232 107.49288 44.253826 0 0 151.74671 -1947.7419 8762.4348 6023.4661 5377.0189 9396.0316 -1629.1364 -1663.1666 -2381.51 + 60 173.10181 -2374.3854 51.097314 33.03646 0 0 84.133774 -1956.4102 4614.2907 1719.1989 505.79149 4552.3167 -1661.1714 -587.92108 -1380.6732 + 70 184.86849 -2391.6106 39.916931 35.978152 0 0 75.895083 -1959.1811 -2146.9339 -4993.4021 -4095.6729 -4897.5768 -833.09046 1542.411 -1539.5266 + 80 164.75795 -2406.3017 101.94229 33.067832 0 0 135.01013 -1953.542 -8779.3265 -10545.409 -10418.702 -12098.858 -1319.194 1750.3511 -275.1272 + 90 151.17491 -2434.6876 152.21826 41.301673 0 0 193.51993 -1949.6141 -13330.691 -15436.505 -13791.461 -16934.674 149.25497 2289.1026 976.14333 + 100 166.99163 -2452.5298 143.57768 35.341459 0 0 178.91914 -1951.5533 -14918.51 -16077.49 -17353.738 -18140.466 19.009088 1487.0469 1084.0231 +Loop time of 3.56341 on 4 procs for 100 steps with 648 atoms + +Performance: 2.425 ns/day, 9.898 hours/ns, 28.063 timesteps/s +100.0% CPU use with 4 MPI tasks x no OpenMP threads + +HIPPO timing breakdown: + Init time: 0.0164761 0.47% + Repulse time: 0.329025 9.29% + Disp time: 0.240825 6.80% + Mpole time: 0.631085 17.81% + Induce time: 1.43692 40.56% + Polar time: 0.807046 22.78% + Qxfer time: 0.081509 2.30% + Total time: 3.5429 + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 3.5358 | 3.5432 | 3.5499 | 0.3 | 99.43 +Bond | 0.00065586 | 0.00073446 | 0.00079512 | 0.0 | 0.02 +Neigh | 0.0016222 | 0.0016303 | 0.0016397 | 0.0 | 0.05 +Comm | 0.0098332 | 0.016538 | 0.023936 | 4.9 | 0.46 +Output | 0.00030555 | 0.00034729 | 0.00046611 | 0.0 | 0.01 +Modify | 0.00020015 | 0.00022223 | 0.00025815 | 0.0 | 0.01 +Other | | 0.0007117 | | | 0.02 + +Nlocal: 162 ave 166 max 160 min +Histogram: 2 0 0 1 0 0 0 0 0 1 +Nghost: 2563.25 ave 2589 max 2535 min +Histogram: 1 1 0 0 0 0 0 0 0 2 +Neighs: 24622.5 ave 25210 max 24056 min +Histogram: 1 0 1 0 0 0 0 1 0 1 + +Total # of neighbors = 98490 +Ave neighs/atom = 151.99074 +Ave special neighs/atom = 2 +Neighbor list builds = 2 +Dangerous builds = 0 +Total wall time: 0:00:03 diff --git a/examples/amoeba/log.5Jul22.water_dimer.amoeba.g++.1 b/examples/amoeba/log.7Jul22.water_dimer.amoeba.g++.1 similarity index 55% rename from examples/amoeba/log.5Jul22.water_dimer.amoeba.g++.1 rename to examples/amoeba/log.7Jul22.water_dimer.amoeba.g++.1 index c9aa2ba0a1..7186a5ed9f 100644 --- a/examples/amoeba/log.5Jul22.water_dimer.amoeba.g++.1 +++ b/examples/amoeba/log.7Jul22.water_dimer.amoeba.g++.1 @@ -1,6 +1,4 @@ LAMMPS (23 Jun 2022) -OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (src/comm.cpp:98) - using 1 OpenMP thread(s) per MPI task # water dimer with AMOEBA or HIPPO units real @@ -41,7 +39,7 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of special neighbors special bonds CPU = 0.000 seconds - read_data CPU = 0.003 seconds + read_data CPU = 0.007 seconds # force field @@ -69,16 +67,12 @@ thermo_style custom step temp epair ebond eangle edihed eimp #dump 1 all custom 10 dump.water_dimer id type x y z fx fy fz #dump_modify 1 sort id -# zero step run - -#run 0 - # dynamics fix 1 all nve -thermo 1 -run 5 +thermo 10 +run 100 AMOEBA force field settings hal: cut 10 taper 8 vscale 0 0 1 1 multipole: cut 10 aewald 0 mscale 0 0 0.4 1 @@ -98,39 +92,44 @@ Neighbor list info ... pair build: half/bin/newton stencil: half/bin/3d bin: standard -WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (src/domain.cpp:970) +WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (../domain.cpp:970) AMOEBA group count: 2 Per MPI rank memory allocation (min/avg/max) = 48.33 | 48.33 | 48.33 Mbytes Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] 0 0 -5.1627563 0.025695395 0.71581114 0 0 0.74150653 -4.4212497 -12260.522 -43226.042 39448.214 -33003.739 -85.160886 -28101.905 -72.971988 - 1 3.4764991 -5.1500622 0.021865831 0.65347737 0 0 0.67534321 -4.4229051 -8987.9108 -37684.452 39410.243 -29356.236 -80.130511 -27322.706 -69.79235 - 2 12.286735 -5.1147506 0.014370337 0.49051077 0 0 0.50488111 -4.4267474 -865.99299 -23430.467 38420.372 -19944.197 -66.155435 -24835.896 -60.583907 - 3 22.599529 -5.0641035 0.0093422156 0.28736734 0 0 0.29670956 -4.4305695 7832.024 -6436.638 34275.274 -8676.6339 -46.038158 -20245.105 -46.202354 - 4 30.447598 -5.0072832 0.0076827791 0.11282886 0 0 0.12051164 -4.432979 12374.854 6652.5061 24658.364 -25.4576 -23.025707 -13137.295 -27.801932 - 5 33.189086 -4.9523094 0.0086012541 0.015399005 0 0 0.024000259 -4.4336573 10023.674 11810.883 8754.5769 3140.658 0.25267021 -3546.6216 -6.83205 -Loop time of 0.000214688 on 1 procs for 5 steps with 6 atoms + 10 1.1174766 -4.7928792 0.045080327 0.30848527 0 0 0.35356559 -4.4226587 -14728.416 11456.119 -52592.829 -3262.8454 70.868937 29494.268 57.977562 + 20 3.0821934 -5.1387316 0.013108182 0.65694692 0 0 0.6700551 -4.4227393 3007.4148 -25925.326 49641.41 -15284.933 -79.726771 -29005.234 -68.530079 + 30 3.461967 -4.8079248 0.013888863 0.31895667 0 0 0.33284554 -4.423482 8616.211 40027.877 -31134.295 16291.126 72.510013 23088.238 51.407946 + 40 4.2181367 -5.0535921 0.0099009766 0.55796811 0 0 0.56786908 -4.4228557 24239.885 -5761.6967 62095.735 15576.675 -76.240192 -33057.385 -58.850871 + 50 5.216657 -4.8012751 0.0053003148 0.29489399 0 0 0.30019431 -4.4233315 17728.056 44785.731 -21215.714 28613.715 66.24671 20292.137 51.010856 + 60 9.45101 -5.0818046 0.0043357361 0.5118733 0 0 0.51620903 -4.4247372 16893.135 -15068.961 50111.11 13824.77 -75.966047 -34809.168 -52.83183 + 70 10.385926 -4.8250769 0.022572262 0.22235766 0 0 0.24492992 -4.4253547 -1117.3665 19070.918 -36063.612 11648.813 61.067533 25754.59 53.919881 + 80 12.797691 -5.123735 0.023756795 0.48275385 0 0 0.50651065 -4.4264869 -6491.9826 -28436.037 20681.908 -14176.121 -64.024669 -35737.052 -52.583533 + 90 12.569481 -4.8303379 0.060369422 0.15670502 0 0 0.21707444 -4.4259273 -16762.536 1720.5855 -47624.986 -6793.7441 59.966729 30024.566 52.339671 + 100 17.750788 -5.1195235 0.039885925 0.38711474 0 0 0.42700067 -4.4279642 -10817.92 -21833.456 4186.8301 -18211.329 -43.11086 -32664.671 -41.508916 +Loop time of 0.0054238 on 1 procs for 100 steps with 6 atoms -Performance: 2012.222 ns/day, 0.012 hours/ns, 23289.611 timesteps/s -65.7% CPU use with 1 MPI tasks x 1 OpenMP threads +Performance: 1592.978 ns/day, 0.015 hours/ns, 18437.244 timesteps/s +98.9% CPU use with 1 MPI tasks x no OpenMP threads AMOEBA timing breakdown: - Init time: 5.306e-06 4.54% - Hal time: 6.681e-06 5.72% - Mpole time: 1.6221e-05 13.88% - Induce time: 5.6723e-05 48.54% - Polar time: 3.1532e-05 26.98% - Total time: 0.000116854 + Init time: 0.000115142 2.36% + Hal time: 0.000417554 8.56% + Mpole time: 0.000572556 11.74% + Induce time: 0.00241105 49.43% + Polar time: 0.0013468 27.61% + Total time: 0.00487742 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.00011888 | 0.00011888 | 0.00011888 | 0.0 | 55.37 -Bond | 3.797e-06 | 3.797e-06 | 3.797e-06 | 0.0 | 1.77 +Pair | 0.0049078 | 0.0049078 | 0.0049078 | 0.0 | 90.49 +Bond | 8.5639e-05 | 8.5639e-05 | 8.5639e-05 | 0.0 | 1.58 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 7.24e-07 | 7.24e-07 | 7.24e-07 | 0.0 | 0.34 -Output | 8.4738e-05 | 8.4738e-05 | 8.4738e-05 | 0.0 | 39.47 -Modify | 1.53e-06 | 1.53e-06 | 1.53e-06 | 0.0 | 0.71 -Other | | 5.022e-06 | | | 2.34 +Comm | 1.3462e-05 | 1.3462e-05 | 1.3462e-05 | 0.0 | 0.25 +Output | 0.00032702 | 0.00032702 | 0.00032702 | 0.0 | 6.03 +Modify | 4.1776e-05 | 4.1776e-05 | 4.1776e-05 | 0.0 | 0.77 +Other | | 4.812e-05 | | | 0.89 Nlocal: 6 ave 6 max 6 min Histogram: 1 0 0 0 0 0 0 0 0 0 diff --git a/examples/amoeba/log.5Jul22.water_dimer.amoeba.g++.4 b/examples/amoeba/log.7Jul22.water_dimer.amoeba.g++.4 similarity index 55% rename from examples/amoeba/log.5Jul22.water_dimer.amoeba.g++.4 rename to examples/amoeba/log.7Jul22.water_dimer.amoeba.g++.4 index 94901fdf24..24526ad8cf 100644 --- a/examples/amoeba/log.5Jul22.water_dimer.amoeba.g++.4 +++ b/examples/amoeba/log.7Jul22.water_dimer.amoeba.g++.4 @@ -1,6 +1,4 @@ LAMMPS (23 Jun 2022) -OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (src/comm.cpp:98) - using 1 OpenMP thread(s) per MPI task # water dimer with AMOEBA or HIPPO units real @@ -41,7 +39,7 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of special neighbors special bonds CPU = 0.000 seconds - read_data CPU = 0.004 seconds + read_data CPU = 0.009 seconds # force field @@ -58,7 +56,7 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of 1-5 neighbors 2 = max # of special neighbors - special bonds CPU = 0.000 seconds + special bonds CPU = 0.001 seconds # thermo output @@ -69,16 +67,12 @@ thermo_style custom step temp epair ebond eangle edihed eimp #dump 1 all custom 10 dump.water_dimer id type x y z fx fy fz #dump_modify 1 sort id -# zero step run - -#run 0 - # dynamics fix 1 all nve -thermo 1 -run 5 +thermo 10 +run 100 AMOEBA force field settings hal: cut 10 taper 8 vscale 0 0 1 1 multipole: cut 10 aewald 0 mscale 0 0 0.4 1 @@ -98,39 +92,44 @@ Neighbor list info ... pair build: half/bin/newton stencil: half/bin/3d bin: standard -WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (src/domain.cpp:970) +WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (../domain.cpp:970) AMOEBA group count: 2 Per MPI rank memory allocation (min/avg/max) = 48.35 | 48.48 | 48.62 Mbytes Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] 0 0 -5.1627563 0.025695395 0.71581114 0 0 0.74150653 -4.4212497 -12260.522 -43226.042 39448.214 -33003.739 -85.160886 -28101.905 -72.971988 - 1 3.4764991 -5.1500622 0.021865831 0.65347737 0 0 0.67534321 -4.4229051 -8987.9108 -37684.452 39410.243 -29356.236 -80.130511 -27322.706 -69.79235 - 2 12.286735 -5.1147506 0.014370337 0.49051077 0 0 0.50488111 -4.4267474 -865.99299 -23430.467 38420.372 -19944.197 -66.155435 -24835.896 -60.583907 - 3 22.599529 -5.0641035 0.0093422156 0.28736734 0 0 0.29670956 -4.4305695 7832.024 -6436.638 34275.274 -8676.6339 -46.038158 -20245.105 -46.202354 - 4 30.447598 -5.0072832 0.0076827791 0.11282886 0 0 0.12051164 -4.432979 12374.854 6652.5061 24658.364 -25.4576 -23.025707 -13137.295 -27.801932 - 5 33.189086 -4.9523094 0.0086012541 0.015399005 0 0 0.024000259 -4.4336573 10023.674 11810.883 8754.5769 3140.658 0.25267021 -3546.6216 -6.83205 -Loop time of 0.000598353 on 4 procs for 5 steps with 6 atoms + 10 1.1174766 -4.7928792 0.045080327 0.30848527 0 0 0.35356559 -4.4226587 -14728.416 11456.119 -52592.829 -3262.8454 70.868937 29494.268 57.977562 + 20 3.0821934 -5.1387316 0.013108182 0.65694692 0 0 0.6700551 -4.4227393 3007.4148 -25925.326 49641.41 -15284.933 -79.726771 -29005.234 -68.530079 + 30 3.461967 -4.8079248 0.013888863 0.31895667 0 0 0.33284554 -4.423482 8616.211 40027.877 -31134.295 16291.126 72.510013 23088.238 51.407946 + 40 4.2181367 -5.0535921 0.0099009766 0.55796811 0 0 0.56786908 -4.4228557 24239.885 -5761.6967 62095.735 15576.675 -76.240192 -33057.385 -58.850871 + 50 5.216657 -4.8012751 0.0053003148 0.29489399 0 0 0.30019431 -4.4233315 17728.056 44785.731 -21215.714 28613.715 66.24671 20292.137 51.010856 + 60 9.45101 -5.0818046 0.0043357361 0.5118733 0 0 0.51620903 -4.4247372 16893.135 -15068.961 50111.11 13824.77 -75.966047 -34809.168 -52.83183 + 70 10.385926 -4.8250769 0.022572262 0.22235766 0 0 0.24492992 -4.4253547 -1117.3665 19070.918 -36063.612 11648.813 61.067533 25754.59 53.919881 + 80 12.797691 -5.123735 0.023756795 0.48275385 0 0 0.50651065 -4.4264869 -6491.9826 -28436.037 20681.908 -14176.121 -64.024669 -35737.052 -52.583533 + 90 12.569481 -4.8303379 0.060369422 0.15670502 0 0 0.21707444 -4.4259273 -16762.536 1720.5855 -47624.986 -6793.7441 59.966729 30024.566 52.339671 + 100 17.750788 -5.1195235 0.039885925 0.38711474 0 0 0.42700067 -4.4279642 -10817.92 -21833.456 4186.8301 -18211.329 -43.11086 -32664.671 -41.508916 +Loop time of 0.0160572 on 4 procs for 100 steps with 6 atoms -Performance: 721.982 ns/day, 0.033 hours/ns, 8356.278 timesteps/s -98.9% CPU use with 4 MPI tasks x 1 OpenMP threads +Performance: 538.077 ns/day, 0.045 hours/ns, 6227.743 timesteps/s +99.9% CPU use with 4 MPI tasks x no OpenMP threads AMOEBA timing breakdown: - Init time: 1.3678e-05 3.81% - Hal time: 3.5045e-06 0.97% - Mpole time: 2.3748e-05 6.61% - Induce time: 0.000284514 79.15% - Polar time: 3.3521e-05 9.33% - Total time: 0.000359445 + Init time: 0.000593411 4.20% + Hal time: 0.000115521 0.82% + Mpole time: 0.000734892 5.20% + Induce time: 0.0115567 81.83% + Polar time: 0.00110812 7.85% + Total time: 0.0141227 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.00035282 | 0.00038565 | 0.00040584 | 0.0 | 64.45 -Bond | 1.637e-06 | 3.2485e-06 | 4.816e-06 | 0.0 | 0.54 +Pair | 0.013932 | 0.014334 | 0.014559 | 0.2 | 89.27 +Bond | 1.1551e-05 | 4.3997e-05 | 8.2514e-05 | 0.0 | 0.27 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 1.4157e-05 | 3.2696e-05 | 5.1431e-05 | 0.0 | 5.46 -Output | 0.00014589 | 0.0001627 | 0.00018978 | 0.0 | 27.19 -Modify | 1.649e-06 | 2.0097e-06 | 2.209e-06 | 0.0 | 0.34 -Other | | 1.205e-05 | | | 2.01 +Comm | 0.00064766 | 0.00080925 | 0.0012349 | 0.0 | 5.04 +Output | 0.00037674 | 0.00043125 | 0.0005388 | 0.0 | 2.69 +Modify | 2.9613e-05 | 3.9056e-05 | 4.4592e-05 | 0.0 | 0.24 +Other | | 0.0003995 | | | 2.49 Nlocal: 1.5 ave 3 max 0 min Histogram: 2 0 0 0 0 0 0 0 0 2 diff --git a/examples/amoeba/log.5Jul22.water_dimer.hippo.g++.1 b/examples/amoeba/log.7Jul22.water_dimer.hippo.g++.1 similarity index 55% rename from examples/amoeba/log.5Jul22.water_dimer.hippo.g++.1 rename to examples/amoeba/log.7Jul22.water_dimer.hippo.g++.1 index dccb8dee21..8689c5963e 100644 --- a/examples/amoeba/log.5Jul22.water_dimer.hippo.g++.1 +++ b/examples/amoeba/log.7Jul22.water_dimer.hippo.g++.1 @@ -1,6 +1,4 @@ LAMMPS (23 Jun 2022) -OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (src/comm.cpp:98) - using 1 OpenMP thread(s) per MPI task # water dimer with AMOEBA or HIPPO units real @@ -41,7 +39,7 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of special neighbors special bonds CPU = 0.000 seconds - read_data CPU = 0.003 seconds + read_data CPU = 0.007 seconds # force field @@ -69,16 +67,12 @@ thermo_style custom step temp epair ebond eangle edihed eimp #dump 1 all custom 10 dump.water_dimer id type x y z fx fy fz #dump_modify 1 sort id -# zero step run - -#run 0 - # dynamics fix 1 all nve -thermo 1 -run 5 +thermo 10 +run 100 HIPPO force field settings repulsion: cut 10 taper 8 rscale 0 0 1 1 qxfer: cut 10 taper 8 mscale 0 0 0.4 1 @@ -100,41 +94,46 @@ Neighbor list info ... pair build: half/bin/newton stencil: half/bin/3d bin: standard -WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (src/domain.cpp:970) +WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (../domain.cpp:970) HIPPO group count: 2 Per MPI rank memory allocation (min/avg/max) = 47.9 | 47.9 | 47.9 Mbytes Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] 0 0 -5.0101954 0.025695395 0.51472748 0 0 0.54042288 -4.4697726 -11875.159 -38149.178 29162.678 -26638.977 -70.63422 -24614.614 -58.505595 - 1 2.8239917 -5.0023563 0.021919009 0.46718 0 0 0.48909901 -4.4711684 -8777.4654 -33285.75 30332.24 -23920.463 -67.159404 -23940.605 -56.913519 - 2 9.9359188 -4.9806071 0.014704278 0.34344685 0 0 0.35815113 -4.4743705 -1094.2989 -20777.766 32507.918 -16918.53 -57.217298 -21702.479 -51.827962 - 3 18.15288 -4.9496234 0.010334146 0.19125791 0 0 0.20159205 -4.47748 7115.3453 -5853.149 32274.916 -8557.0355 -41.982111 -17374.865 -42.455978 - 4 24.248994 -4.9153331 0.0093063079 0.065238074 0 0 0.074544382 -4.4793805 11356.801 5716.9586 25838.412 -2135.3667 -22.820662 -10495.224 -28.045156 - 5 26.136423 -4.8829114 0.0095061937 0.0039834608 0 0 0.013489654 -4.4798832 9044.3732 10498.874 11345.536 276.34491 -1.1467483 -1185.8556 -8.820154 -Loop time of 0.000210439 on 1 procs for 5 steps with 6 atoms + 10 0.75132894 -4.7952077 0.028216017 0.28494196 0 0 0.31315798 -4.4708519 -13243.822 12661.254 -49613.657 -2923.1497 69.449413 29456.684 56.087663 + 20 2.1716525 -5.0036265 0.011809223 0.48875837 0 0 0.50056759 -4.4706925 4371.5298 -22102.532 47044.297 -12243.648 -74.588915 -28903.762 -64.48154 + 30 2.9930198 -4.8261906 0.0091463366 0.30162756 0 0 0.3107739 -4.4708086 9992.4549 41973.539 -20985.339 8415.1715 67.458145 25027.414 40.261795 + 40 3.312268 -4.9802484 0.010400667 0.45076258 0 0 0.46116325 -4.4697189 21565.307 -11602.414 65186.215 10476.902 -83.374203 -33222.094 -64.700001 + 50 4.3187397 -4.8535614 0.0060313545 0.31244652 0 0 0.31847788 -4.4707168 11344.244 45839.35 -21073.749 8438.8954 73.345039 29422.636 43.897876 + 60 4.9127902 -5.0035271 0.0070589202 0.45246538 0 0 0.4595243 -4.4707824 6529.9354 -37107.891 46740.24 9015.2973 -90.41111 -34402.095 -53.57079 + 70 5.3145827 -4.8748857 0.025797484 0.29875503 0 0 0.32455252 -4.4711244 -10208.876 26324.134 -49272.688 -8697.2875 84.479942 36185.667 57.000355 + 80 3.8409793 -5.0262066 0.027669388 0.47104466 0 0 0.49871405 -4.4702464 -9777.1809 -52088.554 28053.855 -6033.4555 -94.607853 -44638.417 -59.108505 + 90 3.0683704 -4.8369716 0.035455716 0.28466932 0 0 0.32012503 -4.4711155 -10626.245 31066.635 -49425.925 -14107.889 87.765958 34632.905 52.101981 + 100 3.5262799 -4.9906817 0.016687539 0.45011301 0 0 0.46680055 -4.4713252 5216.7691 -34991.221 43883.163 6082.1058 -95.830393 -48645.129 -64.784334 +Loop time of 0.00549002 on 1 procs for 100 steps with 6 atoms -Performance: 2052.851 ns/day, 0.012 hours/ns, 23759.854 timesteps/s -98.4% CPU use with 1 MPI tasks x 1 OpenMP threads +Performance: 1573.763 ns/day, 0.015 hours/ns, 18214.853 timesteps/s +98.3% CPU use with 1 MPI tasks x no OpenMP threads HIPPO timing breakdown: - Init time: 5.006e-06 4.58% - Repulse time: 1.3587e-05 12.42% - Disp time: 5.471e-06 5.00% - Mpole time: 2.1321e-05 19.49% - Induce time: 3.7665e-05 34.43% - Polar time: 2.3919e-05 21.87% - Qxfer time: 2.295e-06 2.10% - Total time: 0.000109391 + Init time: 0.000118122 2.43% + Repulse time: 0.000596081 12.26% + Disp time: 0.000298407 6.14% + Mpole time: 0.000966546 19.89% + Induce time: 0.00167417 34.45% + Polar time: 0.00105479 21.70% + Qxfer time: 0.000147142 3.03% + Total time: 0.00486031 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.00011125 | 0.00011125 | 0.00011125 | 0.0 | 52.86 -Bond | 3.062e-06 | 3.062e-06 | 3.062e-06 | 0.0 | 1.46 +Pair | 0.0048915 | 0.0048915 | 0.0048915 | 0.0 | 89.10 +Bond | 7.8835e-05 | 7.8835e-05 | 7.8835e-05 | 0.0 | 1.44 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 6.3e-07 | 6.3e-07 | 6.3e-07 | 0.0 | 0.30 -Output | 8.8087e-05 | 8.8087e-05 | 8.8087e-05 | 0.0 | 41.86 -Modify | 1.664e-06 | 1.664e-06 | 1.664e-06 | 0.0 | 0.79 -Other | | 5.749e-06 | | | 2.73 +Comm | 1.3993e-05 | 1.3993e-05 | 1.3993e-05 | 0.0 | 0.25 +Output | 0.00039472 | 0.00039472 | 0.00039472 | 0.0 | 7.19 +Modify | 4.5208e-05 | 4.5208e-05 | 4.5208e-05 | 0.0 | 0.82 +Other | | 6.581e-05 | | | 1.20 Nlocal: 6 ave 6 max 6 min Histogram: 1 0 0 0 0 0 0 0 0 0 diff --git a/examples/amoeba/log.5Jul22.water_dimer.hippo.g++.4 b/examples/amoeba/log.7Jul22.water_dimer.hippo.g++.4 similarity index 55% rename from examples/amoeba/log.5Jul22.water_dimer.hippo.g++.4 rename to examples/amoeba/log.7Jul22.water_dimer.hippo.g++.4 index 3758759b7a..21daef15a9 100644 --- a/examples/amoeba/log.5Jul22.water_dimer.hippo.g++.4 +++ b/examples/amoeba/log.7Jul22.water_dimer.hippo.g++.4 @@ -1,6 +1,4 @@ LAMMPS (23 Jun 2022) -OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (src/comm.cpp:98) - using 1 OpenMP thread(s) per MPI task # water dimer with AMOEBA or HIPPO units real @@ -41,7 +39,7 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of special neighbors special bonds CPU = 0.000 seconds - read_data CPU = 0.004 seconds + read_data CPU = 0.007 seconds # force field @@ -69,16 +67,12 @@ thermo_style custom step temp epair ebond eangle edihed eimp #dump 1 all custom 10 dump.water_dimer id type x y z fx fy fz #dump_modify 1 sort id -# zero step run - -#run 0 - # dynamics fix 1 all nve -thermo 1 -run 5 +thermo 10 +run 100 HIPPO force field settings repulsion: cut 10 taper 8 rscale 0 0 1 1 qxfer: cut 10 taper 8 mscale 0 0 0.4 1 @@ -100,41 +94,46 @@ Neighbor list info ... pair build: half/bin/newton stencil: half/bin/3d bin: standard -WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (src/domain.cpp:970) +WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (../domain.cpp:970) HIPPO group count: 2 Per MPI rank memory allocation (min/avg/max) = 47.91 | 48.04 | 48.18 Mbytes Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] 0 0 -5.0101954 0.025695395 0.51472748 0 0 0.54042288 -4.4697726 -11875.159 -38149.178 29162.678 -26638.977 -70.63422 -24614.614 -58.505595 - 1 2.8239917 -5.0023563 0.021919009 0.46718 0 0 0.48909901 -4.4711684 -8777.4654 -33285.75 30332.24 -23920.463 -67.159404 -23940.605 -56.913519 - 2 9.9359188 -4.9806071 0.014704278 0.34344685 0 0 0.35815113 -4.4743705 -1094.2989 -20777.766 32507.918 -16918.53 -57.217298 -21702.479 -51.827962 - 3 18.15288 -4.9496234 0.010334146 0.19125791 0 0 0.20159205 -4.47748 7115.3453 -5853.149 32274.916 -8557.0355 -41.982111 -17374.865 -42.455978 - 4 24.248994 -4.9153331 0.0093063079 0.065238074 0 0 0.074544382 -4.4793805 11356.801 5716.9586 25838.412 -2135.3667 -22.820662 -10495.224 -28.045156 - 5 26.136423 -4.8829114 0.0095061937 0.0039834608 0 0 0.013489654 -4.4798832 9044.3732 10498.874 11345.536 276.34491 -1.1467483 -1185.8556 -8.820154 -Loop time of 0.000488464 on 4 procs for 5 steps with 6 atoms + 10 0.75132894 -4.7952077 0.028216017 0.28494196 0 0 0.31315798 -4.4708519 -13243.822 12661.254 -49613.657 -2923.1497 69.449413 29456.684 56.087663 + 20 2.1716525 -5.0036265 0.011809223 0.48875837 0 0 0.50056759 -4.4706925 4371.5298 -22102.532 47044.297 -12243.648 -74.588915 -28903.762 -64.48154 + 30 2.9930198 -4.8261906 0.0091463366 0.30162756 0 0 0.3107739 -4.4708086 9992.4549 41973.539 -20985.339 8415.1715 67.458145 25027.414 40.261795 + 40 3.312268 -4.9802484 0.010400667 0.45076258 0 0 0.46116325 -4.4697189 21565.307 -11602.414 65186.215 10476.902 -83.374203 -33222.094 -64.700001 + 50 4.3187397 -4.8535614 0.0060313545 0.31244652 0 0 0.31847788 -4.4707168 11344.244 45839.35 -21073.749 8438.8954 73.345039 29422.636 43.897876 + 60 4.9127902 -5.0035271 0.0070589202 0.45246538 0 0 0.4595243 -4.4707824 6529.9354 -37107.891 46740.24 9015.2973 -90.41111 -34402.095 -53.57079 + 70 5.3145827 -4.8748857 0.025797484 0.29875503 0 0 0.32455252 -4.4711244 -10208.876 26324.134 -49272.688 -8697.2875 84.479942 36185.667 57.000355 + 80 3.8409793 -5.0262066 0.027669388 0.47104466 0 0 0.49871405 -4.4702464 -9777.1809 -52088.554 28053.855 -6033.4555 -94.607853 -44638.417 -59.108505 + 90 3.0683704 -4.8369716 0.035455716 0.28466932 0 0 0.32012503 -4.4711155 -10626.245 31066.635 -49425.925 -14107.889 87.765958 34632.905 52.101981 + 100 3.5262799 -4.9906817 0.016687539 0.45011301 0 0 0.46680055 -4.4713252 5216.7691 -34991.221 43883.163 6082.1058 -95.830393 -48645.129 -64.784334 +Loop time of 0.0111155 on 4 procs for 100 steps with 6 atoms -Performance: 884.405 ns/day, 0.027 hours/ns, 10236.169 timesteps/s -70.9% CPU use with 4 MPI tasks x 1 OpenMP threads +Performance: 777.294 ns/day, 0.031 hours/ns, 8996.461 timesteps/s +98.1% CPU use with 4 MPI tasks x no OpenMP threads HIPPO timing breakdown: - Init time: 1.2924e-05 4.50% - Repulse time: 2.01283e-05 7.01% - Disp time: 3.04475e-06 1.06% - Mpole time: 3.51807e-05 12.25% - Induce time: 0.000183034 63.71% - Polar time: 3.13832e-05 10.92% - Qxfer time: 1.44475e-06 0.50% - Total time: 0.000287298 + Init time: 0.000522591 5.56% + Repulse time: 0.000518986 5.52% + Disp time: 7.85217e-05 0.84% + Mpole time: 0.000799739 8.51% + Induce time: 0.00666551 70.95% + Polar time: 0.000761531 8.11% + Qxfer time: 4.34115e-05 0.46% + Total time: 0.00939447 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.00028193 | 0.00030553 | 0.00032173 | 0.0 | 62.55 -Bond | 1.317e-06 | 2.7712e-06 | 4.847e-06 | 0.0 | 0.57 +Pair | 0.0093886 | 0.0095904 | 0.009719 | 0.1 | 86.28 +Bond | 1.1102e-05 | 3.5048e-05 | 6.4101e-05 | 0.0 | 0.32 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 1.3015e-05 | 3.0698e-05 | 4.1342e-05 | 0.0 | 6.28 -Output | 0.00012315 | 0.00013964 | 0.00015356 | 0.0 | 28.59 -Modify | 1.445e-06 | 1.881e-06 | 2.366e-06 | 0.0 | 0.39 -Other | | 7.949e-06 | | | 1.63 +Comm | 0.00058179 | 0.0007073 | 0.00089017 | 0.0 | 6.36 +Output | 0.00033655 | 0.00038862 | 0.00047709 | 0.0 | 3.50 +Modify | 2.5893e-05 | 3.3791e-05 | 3.9341e-05 | 0.0 | 0.30 +Other | | 0.0003603 | | | 3.24 Nlocal: 1.5 ave 3 max 0 min Histogram: 2 0 0 0 0 0 0 0 0 2 diff --git a/examples/amoeba/log.5Jul22.water_hexamer.amoeba.g++.1 b/examples/amoeba/log.7Jul22.water_hexamer.amoeba.g++.1 similarity index 55% rename from examples/amoeba/log.5Jul22.water_hexamer.amoeba.g++.1 rename to examples/amoeba/log.7Jul22.water_hexamer.amoeba.g++.1 index 03224a076e..6e197a02fc 100644 --- a/examples/amoeba/log.5Jul22.water_hexamer.amoeba.g++.1 +++ b/examples/amoeba/log.7Jul22.water_hexamer.amoeba.g++.1 @@ -1,6 +1,4 @@ LAMMPS (23 Jun 2022) -OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (src/comm.cpp:98) - using 1 OpenMP thread(s) per MPI task # water hexamer with AMOEBA or HIPPO units real @@ -41,7 +39,7 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of special neighbors special bonds CPU = 0.000 seconds - read_data CPU = 0.003 seconds + read_data CPU = 0.007 seconds # force field @@ -69,16 +67,12 @@ thermo_style custom step temp epair ebond eangle edihed eimp #dump 1 all custom 10 dump.water_hexamer id type x y z fx fy fz #dump_modify 1 sort id -# zero step run - -#run 0 - # dynamics fix 1 all nve -thermo 1 -run 5 +thermo 10 +run 100 AMOEBA force field settings hal: cut 10 taper 8 vscale 0 0 1 1 multipole: cut 10 aewald 0 mscale 0 0 0.4 1 @@ -102,34 +96,39 @@ Neighbor list info ... Per MPI rank memory allocation (min/avg/max) = 48.28 | 48.28 | 48.28 Mbytes Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] 0 0 -48.469664 1.9820353 2.2499329 0 0 4.2319683 -44.237696 -26322.671 -28303.103 -27669.614 -22995.296 1312.6688 2624.8394 4042.0489 - 1 5.318656 -48.202382 1.5369859 2.1322394 0 0 3.6692253 -44.26364 -20236.446 -20385.617 -23104.961 -17727.152 417.52781 2728.2976 3750.7708 - 2 14.415671 -47.491537 0.6389772 1.8136212 0 0 2.4525984 -44.308442 -4127.4968 1051.8436 -10980.156 -3832.1256 -2285.3376 2991.8274 2945.888 - 3 15.996484 -46.59119 0.087228651 1.3862662 0 0 1.4734948 -44.307093 15705.166 28374.161 4124.662 13087.621 -6242.1769 3159.6508 1787.4159 - 4 10.888785 -45.839064 0.062461924 0.96598997 0 0 1.0284519 -44.258837 30226.38 48920.372 15666.108 25051.837 -9443.9251 2603.8275 435.5257 - 5 10.58575 -45.503287 0.071817565 0.64254674 0 0 0.71436431 -44.252503 31899.04 51066.283 18170.57 25448.409 -9478.6752 638.72265 -1011.7679 -Loop time of 0.00100127 on 1 procs for 5 steps with 18 atoms + 10 6.3616471 -46.626437 1.7910812 0.25704063 0 0 2.0481218 -44.255947 -23813.06 -24671.886 -17167.34 -30208.043 -474.208 -8339.5934 -5278.359 + 20 15.149798 -48.177533 1.1130818 2.007499 0 0 3.1205807 -44.289255 -16468.855 -20150.975 -18596.629 -12107.083 885.52697 6320.1867 3064.949 + 30 17.896968 -45.959274 0.54802739 0.19519937 0 0 0.74322676 -44.309141 -4749.0624 -9053.7792 -182.37209 -6721.7499 -2003.7641 -627.56998 -1658.1301 + 40 16.203813 -46.840973 0.1371751 1.5793326 0 0 1.7165077 -44.303357 9267.4858 6108.7966 4116.4548 16028.336 380.03787 8468.0648 4492.3331 + 50 11.584975 -45.166711 0.017120512 0.28622888 0 0 0.30334939 -44.276308 22189.511 21453.083 22339.471 21668.607 150.93139 1059.5253 200.0668 + 60 10.002055 -45.994946 0.037889337 1.1987062 0 0 1.2365956 -44.251509 30944.004 35801.925 19832.696 36241.326 2042.3054 2320.5193 1660.0834 + 70 11.272241 -45.411622 0.07431614 0.51778317 0 0 0.59209931 -44.248316 32055.564 39306.193 30181.52 25601.501 1373.4778 -4501.0686 -2570.4767 + 80 14.011502 -46.081444 0.089688317 1.006928 0 0 1.0966163 -44.274812 25661.838 38836.598 12603.734 24205.867 -867.36437 -4211.9639 -2820.6725 + 90 17.659498 -46.247295 0.21744649 0.82687716 0 0 1.0443237 -44.308098 12101.207 19426.995 14142.311 1046.299 -2157.5418 -2141.2454 -2621.456 + 100 17.630532 -46.788272 0.61811601 0.9654966 0 0 1.5836126 -44.311254 -4455.3587 3961.5737 -11554.095 -7458.8012 -3120.9771 -1532.1706 -1499.0117 +Loop time of 0.0422729 on 1 procs for 100 steps with 18 atoms -Performance: 431.450 ns/day, 0.056 hours/ns, 4993.633 timesteps/s -99.8% CPU use with 1 MPI tasks x 1 OpenMP threads +Performance: 204.386 ns/day, 0.117 hours/ns, 2365.584 timesteps/s +99.1% CPU use with 1 MPI tasks x no OpenMP threads AMOEBA timing breakdown: - Init time: 1.2944e-05 1.45% - Hal time: 6.4578e-05 7.21% - Mpole time: 0.000124703 13.93% - Induce time: 0.000435232 48.60% - Polar time: 0.000257613 28.77% - Total time: 0.000895454 + Init time: 0.000326361 0.79% + Hal time: 0.00514709 12.41% + Mpole time: 0.00443325 10.69% + Induce time: 0.0203454 49.05% + Polar time: 0.0112122 27.03% + Total time: 0.0414795 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.00089735 | 0.00089735 | 0.00089735 | 0.0 | 89.62 -Bond | 6.783e-06 | 6.783e-06 | 6.783e-06 | 0.0 | 0.68 +Pair | 0.041518 | 0.041518 | 0.041518 | 0.0 | 98.21 +Bond | 0.00021732 | 0.00021732 | 0.00021732 | 0.0 | 0.51 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 6.36e-07 | 6.36e-07 | 6.36e-07 | 0.0 | 0.06 -Output | 8.9119e-05 | 8.9119e-05 | 8.9119e-05 | 0.0 | 8.90 -Modify | 2.385e-06 | 2.385e-06 | 2.385e-06 | 0.0 | 0.24 -Other | | 4.998e-06 | | | 0.50 +Comm | 1.4363e-05 | 1.4363e-05 | 1.4363e-05 | 0.0 | 0.03 +Output | 0.00037904 | 0.00037904 | 0.00037904 | 0.0 | 0.90 +Modify | 7.8692e-05 | 7.8692e-05 | 7.8692e-05 | 0.0 | 0.19 +Other | | 6.519e-05 | | | 0.15 Nlocal: 18 ave 18 max 18 min Histogram: 1 0 0 0 0 0 0 0 0 0 diff --git a/examples/amoeba/log.5Jul22.water_hexamer.amoeba.g++.4 b/examples/amoeba/log.7Jul22.water_hexamer.amoeba.g++.4 similarity index 55% rename from examples/amoeba/log.5Jul22.water_hexamer.amoeba.g++.4 rename to examples/amoeba/log.7Jul22.water_hexamer.amoeba.g++.4 index 1f5aff9134..0c3ad2a657 100644 --- a/examples/amoeba/log.5Jul22.water_hexamer.amoeba.g++.4 +++ b/examples/amoeba/log.7Jul22.water_hexamer.amoeba.g++.4 @@ -1,6 +1,4 @@ LAMMPS (23 Jun 2022) -OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (src/comm.cpp:98) - using 1 OpenMP thread(s) per MPI task # water hexamer with AMOEBA or HIPPO units real @@ -41,7 +39,7 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of special neighbors special bonds CPU = 0.000 seconds - read_data CPU = 0.004 seconds + read_data CPU = 0.008 seconds # force field @@ -69,16 +67,12 @@ thermo_style custom step temp epair ebond eangle edihed eimp #dump 1 all custom 10 dump.water_hexamer id type x y z fx fy fz #dump_modify 1 sort id -# zero step run - -#run 0 - # dynamics fix 1 all nve -thermo 1 -run 5 +thermo 10 +run 100 AMOEBA force field settings hal: cut 10 taper 8 vscale 0 0 1 1 multipole: cut 10 aewald 0 mscale 0 0 0.4 1 @@ -98,39 +92,44 @@ Neighbor list info ... pair build: half/bin/newton stencil: half/bin/3d bin: standard -WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (src/domain.cpp:970) +WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (../domain.cpp:970) AMOEBA group count: 6 Per MPI rank memory allocation (min/avg/max) = 48.3 | 48.3 | 48.3 Mbytes Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] 0 0 -48.469664 1.9820353 2.2499329 0 0 4.2319683 -44.237696 -26322.671 -28303.103 -27669.614 -22995.296 1312.6688 2624.8394 4042.0489 - 1 5.318656 -48.202382 1.5369859 2.1322394 0 0 3.6692253 -44.26364 -20236.446 -20385.617 -23104.961 -17727.152 417.52781 2728.2976 3750.7708 - 2 14.415671 -47.491537 0.6389772 1.8136212 0 0 2.4525984 -44.308442 -4127.4968 1051.8436 -10980.156 -3832.1256 -2285.3376 2991.8274 2945.888 - 3 15.996484 -46.59119 0.087228651 1.3862662 0 0 1.4734948 -44.307093 15705.166 28374.161 4124.662 13087.621 -6242.1769 3159.6508 1787.4159 - 4 10.888785 -45.839064 0.062461924 0.96598997 0 0 1.0284519 -44.258837 30226.38 48920.372 15666.108 25051.837 -9443.9251 2603.8275 435.5257 - 5 10.58575 -45.503287 0.071817565 0.64254674 0 0 0.71436431 -44.252503 31899.04 51066.283 18170.57 25448.409 -9478.6752 638.72265 -1011.7679 -Loop time of 0.00124102 on 4 procs for 5 steps with 18 atoms + 10 6.3616471 -46.626437 1.7910812 0.25704063 0 0 2.0481218 -44.255947 -23813.06 -24671.886 -17167.34 -30208.043 -474.208 -8339.5934 -5278.359 + 20 15.149798 -48.177533 1.1130818 2.007499 0 0 3.1205807 -44.289255 -16468.855 -20150.975 -18596.629 -12107.083 885.52697 6320.1867 3064.949 + 30 17.896968 -45.959274 0.54802739 0.19519937 0 0 0.74322676 -44.309141 -4749.0624 -9053.7792 -182.37209 -6721.7499 -2003.7641 -627.56998 -1658.1301 + 40 16.203813 -46.840973 0.1371751 1.5793326 0 0 1.7165077 -44.303357 9267.4858 6108.7966 4116.4548 16028.336 380.03787 8468.0648 4492.3331 + 50 11.584975 -45.166711 0.017120512 0.28622888 0 0 0.30334939 -44.276308 22189.511 21453.083 22339.471 21668.607 150.93139 1059.5253 200.0668 + 60 10.002055 -45.994946 0.037889337 1.1987062 0 0 1.2365956 -44.251509 30944.004 35801.925 19832.696 36241.326 2042.3054 2320.5193 1660.0834 + 70 11.272241 -45.411622 0.07431614 0.51778317 0 0 0.59209931 -44.248316 32055.564 39306.193 30181.52 25601.501 1373.4778 -4501.0686 -2570.4767 + 80 14.011502 -46.081444 0.089688317 1.006928 0 0 1.0966163 -44.274812 25661.838 38836.598 12603.734 24205.867 -867.36437 -4211.9639 -2820.6725 + 90 17.659498 -46.247295 0.21744649 0.82687716 0 0 1.0443237 -44.308098 12101.207 19426.995 14142.311 1046.299 -2157.5418 -2141.2454 -2621.456 + 100 17.630532 -46.788272 0.61811601 0.9654966 0 0 1.5836126 -44.311254 -4455.3587 3961.5737 -11554.095 -7458.8012 -3120.9771 -1532.1706 -1499.0117 +Loop time of 0.0414203 on 4 procs for 100 steps with 18 atoms -Performance: 348.100 ns/day, 0.069 hours/ns, 4028.938 timesteps/s -99.4% CPU use with 4 MPI tasks x 1 OpenMP threads +Performance: 208.593 ns/day, 0.115 hours/ns, 2414.273 timesteps/s +100.0% CPU use with 4 MPI tasks x no OpenMP threads AMOEBA timing breakdown: - Init time: 1.93587e-05 1.89% - Hal time: 2.20198e-05 2.15% - Mpole time: 0.0001019 9.94% - Induce time: 0.000717017 69.95% - Polar time: 0.000164237 16.02% - Total time: 0.00102505 + Init time: 0.000755971 1.92% + Hal time: 0.00126807 3.22% + Mpole time: 0.00372714 9.45% + Induce time: 0.0278954 70.76% + Polar time: 0.00576419 14.62% + Total time: 0.0394242 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.0010331 | 0.0010362 | 0.0010375 | 0.0 | 83.50 -Bond | 3.723e-06 | 5.0355e-06 | 5.6e-06 | 0.0 | 0.41 +Pair | 0.039586 | 0.039644 | 0.039746 | 0.0 | 95.71 +Bond | 6.0994e-05 | 8.2233e-05 | 9.988e-05 | 0.0 | 0.20 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 1.7872e-05 | 4.1093e-05 | 6.4155e-05 | 0.0 | 3.31 -Output | 0.00012756 | 0.00014764 | 0.00016933 | 0.0 | 11.90 -Modify | 1.808e-06 | 2.4647e-06 | 2.74e-06 | 0.0 | 0.20 -Other | | 8.565e-06 | | | 0.69 +Comm | 0.00069921 | 0.00087777 | 0.001002 | 0.0 | 2.12 +Output | 0.00035764 | 0.00040122 | 0.00052238 | 0.0 | 0.97 +Modify | 4.6185e-05 | 5.6938e-05 | 6.2738e-05 | 0.0 | 0.14 +Other | | 0.0003586 | | | 0.87 Nlocal: 4.5 ave 6 max 3 min Histogram: 1 0 0 1 0 0 1 0 0 1 diff --git a/examples/amoeba/log.5Jul22.water_hexamer.hippo.g++.1 b/examples/amoeba/log.7Jul22.water_hexamer.hippo.g++.1 similarity index 55% rename from examples/amoeba/log.5Jul22.water_hexamer.hippo.g++.1 rename to examples/amoeba/log.7Jul22.water_hexamer.hippo.g++.1 index e6a765c0e8..fc6704c681 100644 --- a/examples/amoeba/log.5Jul22.water_hexamer.hippo.g++.1 +++ b/examples/amoeba/log.7Jul22.water_hexamer.hippo.g++.1 @@ -1,6 +1,4 @@ LAMMPS (23 Jun 2022) -OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (src/comm.cpp:98) - using 1 OpenMP thread(s) per MPI task # water hexamer with AMOEBA or HIPPO units real @@ -41,7 +39,7 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of special neighbors special bonds CPU = 0.000 seconds - read_data CPU = 0.003 seconds + read_data CPU = 0.007 seconds # force field @@ -69,16 +67,12 @@ thermo_style custom step temp epair ebond eangle edihed eimp #dump 1 all custom 10 dump.water_hexamer id type x y z fx fy fz #dump_modify 1 sort id -# zero step run - -#run 0 - # dynamics fix 1 all nve -thermo 1 -run 5 +thermo 10 +run 100 HIPPO force field settings repulsion: cut 10 taper 8 rscale 0 0 1 1 qxfer: cut 10 taper 8 mscale 0 0 0.4 1 @@ -104,36 +98,41 @@ Neighbor list info ... Per MPI rank memory allocation (min/avg/max) = 47.84 | 47.84 | 47.84 Mbytes Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] 0 0 -47.362156 1.9820353 1.6634749 0 0 3.6455102 -43.716646 -34513.768 -42206.078 -31383.641 -29951.584 2850.1184 3579.9253 5768.3698 - 1 7.1819351 -47.135822 1.4553325 1.5620463 0 0 3.0173788 -43.754508 -26763.923 -32046.377 -25919.73 -23012.16 1848.028 3578.5744 5396.0234 - 2 18.776762 -46.526843 0.46636815 1.2906982 0 0 1.7570664 -43.818287 -6352.6601 -4602.4631 -11460.465 -4789.8629 -1296.5558 3625.7641 4391.7607 - 3 19.013509 -45.750445 0.043880608 0.9336078 0 0 0.97748841 -43.809471 18351.549 29896.314 6275.5012 17065.39 -6055.8639 3664.6024 3015.6633 - 4 11.017518 -45.12347 0.24124811 0.58878104 0 0 0.83002915 -43.735142 35358.63 54252.632 19050.919 31719.21 -9822.7607 3160.7845 1520.1368 - 5 12.143149 -44.904245 0.22320916 0.3270434 0 0 0.55025256 -43.738653 35160.919 53395.572 20272.979 30653.482 -9511.0241 1392.4959 35.692826 -Loop time of 0.000984386 on 1 procs for 5 steps with 18 atoms + 10 11.52238 -45.959856 1.53397 0.085100522 0 0 1.6190706 -43.756903 -28644.676 -34867.94 -19324.955 -32842.522 -370.63233 -6452.0859 -4002.3535 + 20 20.237283 -46.772008 0.54762833 1.3835192 0 0 1.9311476 -43.815361 -10546.356 -10116.359 -17063.425 -6393.701 -1166.7608 4243.6327 3493.9596 + 30 20.666374 -45.011106 0.086797459 0.071122604 0 0 0.15792006 -43.805943 13150.762 15882.022 10964.553 10630.278 -6754.7642 -432.29165 -3783.115 + 40 10.639014 -45.430939 0.18926921 0.96410995 0 0 1.1533792 -43.738441 33402.664 41252.58 19726.586 38211.875 -6166.03 6081.5692 1815.7739 + 50 10.992432 -44.741108 0.19575431 0.25851128 0 0 0.45426559 -43.729815 37696.923 41572.466 33299.43 37168.141 -3254.5134 2.9639226 -1017.3669 + 60 19.748633 -45.461264 0.035287281 0.63217389 0 0 0.66746117 -43.793065 26212.839 28825.788 16048.096 31876.925 3504.5461 135.3505 420.28566 + 70 26.129957 -46.022729 0.30434543 0.56770169 0 0 0.87204711 -43.826579 3919.9866 -2755.6905 11500.428 517.54333 5626.9543 -2238.5786 86.305984 + 80 17.768494 -46.309777 1.1680612 0.45551823 0 0 1.6235794 -43.785801 -18335.898 -22168.789 -14488.992 -20048.346 7343.173 -2646.2196 -2525.6625 + 90 8.3822494 -47.063502 2.0182644 0.88875358 0 0 2.9070179 -43.731724 -33693.203 -43487.996 -15178.35 -43214.494 2412.6411 1993.0113 1780.7512 + 100 8.6486333 -46.517402 1.9551958 0.38696887 0 0 2.3421647 -43.736979 -34734.97 -34372.659 -28372.146 -42286.799 226.18821 40.353457 -755.93912 +Loop time of 0.0380494 on 1 procs for 100 steps with 18 atoms -Performance: 438.852 ns/day, 0.055 hours/ns, 5079.308 timesteps/s -99.8% CPU use with 1 MPI tasks x 1 OpenMP threads +Performance: 227.073 ns/day, 0.106 hours/ns, 2628.163 timesteps/s +99.8% CPU use with 1 MPI tasks x no OpenMP threads HIPPO timing breakdown: - Init time: 1.2669e-05 1.45% - Repulse time: 0.000132325 15.15% - Disp time: 4.2534e-05 4.87% - Mpole time: 0.000177341 20.30% - Induce time: 0.000303723 34.77% - Polar time: 0.000179318 20.53% - Qxfer time: 2.5413e-05 2.91% - Total time: 0.000873466 + Init time: 0.000298991 0.80% + Repulse time: 0.00610364 16.36% + Disp time: 0.00215934 5.79% + Mpole time: 0.00717983 19.24% + Induce time: 0.0128706 34.49% + Polar time: 0.00726207 19.46% + Qxfer time: 0.00143879 3.86% + Total time: 0.0373178 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.00087559 | 0.00087559 | 0.00087559 | 0.0 | 88.95 -Bond | 6.455e-06 | 6.455e-06 | 6.455e-06 | 0.0 | 0.66 +Pair | 0.037354 | 0.037354 | 0.037354 | 0.0 | 98.17 +Bond | 0.0001712 | 0.0001712 | 0.0001712 | 0.0 | 0.45 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 7.87e-07 | 7.87e-07 | 7.87e-07 | 0.0 | 0.08 -Output | 9.3142e-05 | 9.3142e-05 | 9.3142e-05 | 0.0 | 9.46 -Modify | 2.351e-06 | 2.351e-06 | 2.351e-06 | 0.0 | 0.24 -Other | | 6.065e-06 | | | 0.62 +Comm | 1.5977e-05 | 1.5977e-05 | 1.5977e-05 | 0.0 | 0.04 +Output | 0.00036487 | 0.00036487 | 0.00036487 | 0.0 | 0.96 +Modify | 6.9428e-05 | 6.9428e-05 | 6.9428e-05 | 0.0 | 0.18 +Other | | 7.438e-05 | | | 0.20 Nlocal: 18 ave 18 max 18 min Histogram: 1 0 0 0 0 0 0 0 0 0 diff --git a/examples/amoeba/log.5Jul22.water_hexamer.hippo.g++.4 b/examples/amoeba/log.7Jul22.water_hexamer.hippo.g++.4 similarity index 55% rename from examples/amoeba/log.5Jul22.water_hexamer.hippo.g++.4 rename to examples/amoeba/log.7Jul22.water_hexamer.hippo.g++.4 index 02d9b0f6f2..99730d3da4 100644 --- a/examples/amoeba/log.5Jul22.water_hexamer.hippo.g++.4 +++ b/examples/amoeba/log.7Jul22.water_hexamer.hippo.g++.4 @@ -1,6 +1,4 @@ LAMMPS (23 Jun 2022) -OMP_NUM_THREADS environment is not set. Defaulting to 1 thread. (src/comm.cpp:98) - using 1 OpenMP thread(s) per MPI task # water hexamer with AMOEBA or HIPPO units real @@ -41,7 +39,7 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of special neighbors special bonds CPU = 0.000 seconds - read_data CPU = 0.004 seconds + read_data CPU = 0.008 seconds # force field @@ -58,7 +56,7 @@ Finding 1-2 1-3 1-4 neighbors ... 1 = max # of 1-4 neighbors 2 = max # of 1-5 neighbors 2 = max # of special neighbors - special bonds CPU = 0.000 seconds + special bonds CPU = 0.001 seconds # thermo output @@ -69,16 +67,12 @@ thermo_style custom step temp epair ebond eangle edihed eimp #dump 1 all custom 10 dump.water_hexamer id type x y z fx fy fz #dump_modify 1 sort id -# zero step run - -#run 0 - # dynamics fix 1 all nve -thermo 1 -run 5 +thermo 10 +run 100 HIPPO force field settings repulsion: cut 10 taper 8 rscale 0 0 1 1 qxfer: cut 10 taper 8 mscale 0 0 0.4 1 @@ -100,41 +94,46 @@ Neighbor list info ... pair build: half/bin/newton stencil: half/bin/3d bin: standard -WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (src/domain.cpp:970) +WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (../domain.cpp:970) HIPPO group count: 6 Per MPI rank memory allocation (min/avg/max) = 47.86 | 47.86 | 47.86 Mbytes Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] 0 0 -47.362156 1.9820353 1.6634749 0 0 3.6455102 -43.716646 -34513.768 -42206.078 -31383.641 -29951.584 2850.1184 3579.9253 5768.3698 - 1 7.1819351 -47.135822 1.4553325 1.5620463 0 0 3.0173788 -43.754508 -26763.923 -32046.377 -25919.73 -23012.16 1848.028 3578.5744 5396.0234 - 2 18.776762 -46.526843 0.46636815 1.2906982 0 0 1.7570664 -43.818287 -6352.6601 -4602.4631 -11460.465 -4789.8629 -1296.5558 3625.7641 4391.7607 - 3 19.013509 -45.750445 0.043880608 0.9336078 0 0 0.97748841 -43.809471 18351.549 29896.314 6275.5012 17065.39 -6055.8639 3664.6024 3015.6633 - 4 11.017518 -45.12347 0.24124811 0.58878104 0 0 0.83002915 -43.735142 35358.63 54252.632 19050.919 31719.21 -9822.7607 3160.7845 1520.1368 - 5 12.143149 -44.904245 0.22320916 0.3270434 0 0 0.55025256 -43.738653 35160.919 53395.572 20272.979 30653.482 -9511.0241 1392.4959 35.692826 -Loop time of 0.00126451 on 4 procs for 5 steps with 18 atoms + 10 11.52238 -45.959856 1.53397 0.085100522 0 0 1.6190706 -43.756903 -28644.676 -34867.94 -19324.955 -32842.522 -370.63233 -6452.0859 -4002.3535 + 20 20.237283 -46.772008 0.54762833 1.3835192 0 0 1.9311476 -43.815361 -10546.356 -10116.359 -17063.425 -6393.701 -1166.7608 4243.6327 3493.9596 + 30 20.666374 -45.011106 0.086797459 0.071122604 0 0 0.15792006 -43.805943 13150.762 15882.022 10964.553 10630.278 -6754.7642 -432.29165 -3783.115 + 40 10.639014 -45.430939 0.18926921 0.96410995 0 0 1.1533792 -43.738441 33402.664 41252.58 19726.586 38211.875 -6166.03 6081.5692 1815.7739 + 50 10.992432 -44.741108 0.19575431 0.25851128 0 0 0.45426559 -43.729815 37696.923 41572.466 33299.43 37168.141 -3254.5134 2.9639226 -1017.3669 + 60 19.748633 -45.461264 0.035287281 0.63217389 0 0 0.66746117 -43.793065 26212.839 28825.788 16048.096 31876.925 3504.5461 135.3505 420.28566 + 70 26.129957 -46.022729 0.30434543 0.56770169 0 0 0.87204711 -43.826579 3919.9866 -2755.6905 11500.428 517.54333 5626.9543 -2238.5786 86.305984 + 80 17.768494 -46.309777 1.1680612 0.45551823 0 0 1.6235794 -43.785801 -18335.898 -22168.789 -14488.992 -20048.346 7343.173 -2646.2196 -2525.6625 + 90 8.3822494 -47.063502 2.0182644 0.88875358 0 0 2.9070179 -43.731724 -33693.203 -43487.996 -15178.35 -43214.494 2412.6411 1993.0113 1780.7512 + 100 8.6486333 -46.517402 1.9551958 0.38696887 0 0 2.3421647 -43.736979 -34734.97 -34372.659 -28372.146 -42286.799 226.18821 40.353457 -755.93912 +Loop time of 0.0319956 on 4 procs for 100 steps with 18 atoms -Performance: 341.634 ns/day, 0.070 hours/ns, 3954.096 timesteps/s -92.2% CPU use with 4 MPI tasks x 1 OpenMP threads +Performance: 270.038 ns/day, 0.089 hours/ns, 3125.434 timesteps/s +99.7% CPU use with 4 MPI tasks x no OpenMP threads HIPPO timing breakdown: - Init time: 1.75712e-05 1.72% - Repulse time: 0.000116156 11.39% - Disp time: 1.69788e-05 1.66% - Mpole time: 0.000178714 17.52% - Induce time: 0.000515806 50.57% - Polar time: 0.0001659 16.27% - Qxfer time: 8.64975e-06 0.85% - Total time: 0.00101993 + Init time: 0.000692588 2.32% + Repulse time: 0.00294464 9.88% + Disp time: 0.000526361 1.77% + Mpole time: 0.00377225 12.66% + Induce time: 0.0178884 60.04% + Polar time: 0.00361349 12.13% + Qxfer time: 0.000349507 1.17% + Total time: 0.0297917 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.0010223 | 0.0010316 | 0.001045 | 0.0 | 81.58 -Bond | 3.062e-06 | 4.3805e-06 | 5.123e-06 | 0.0 | 0.35 +Pair | 0.029692 | 0.029996 | 0.030382 | 0.2 | 93.75 +Bond | 5.5693e-05 | 6.9151e-05 | 8.2812e-05 | 0.0 | 0.22 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 1.4853e-05 | 6.5245e-05 | 9.2753e-05 | 0.0 | 5.16 -Output | 0.0001294 | 0.00014959 | 0.00018927 | 0.0 | 11.83 -Modify | 1.595e-06 | 2.2495e-06 | 2.798e-06 | 0.0 | 0.18 -Other | | 1.145e-05 | | | 0.91 +Comm | 0.00066534 | 0.0011191 | 0.0014774 | 1.0 | 3.50 +Output | 0.00036537 | 0.00040732 | 0.00052168 | 0.0 | 1.27 +Modify | 4.6407e-05 | 5.1041e-05 | 5.4068e-05 | 0.0 | 0.16 +Other | | 0.0003526 | | | 1.10 Nlocal: 4.5 ave 6 max 3 min Histogram: 1 0 0 1 0 0 1 0 0 1 diff --git a/src/AMOEBA/amoeba_induce.cpp b/src/AMOEBA/amoeba_induce.cpp index 12baf440e1..3723050326 100644 --- a/src/AMOEBA/amoeba_induce.cpp +++ b/src/AMOEBA/amoeba_induce.cpp @@ -388,7 +388,8 @@ void PairAmoeba::induce() // NOTE: could make this an error if (iter >= maxiter || eps > epsold) - if (comm->me == 0) error->warning(FLERR,"AMOEBA induced dipoles did not converge"); + if (comm->me == 0) + error->warning(FLERR,"AMOEBA induced dipoles did not converge"); } // update the lists of previous induced dipole values diff --git a/src/AMOEBA/amoeba_utils.cpp b/src/AMOEBA/amoeba_utils.cpp index c96f7f305c..b01b9f11b6 100644 --- a/src/AMOEBA/amoeba_utils.cpp +++ b/src/AMOEBA/amoeba_utils.cpp @@ -74,7 +74,7 @@ void PairAmoeba::kmpole() // create a sorted version of bond/angle neighs from special[][] // NOTE: this is to try and do it identically to Tinker - // b/c I think in Tinker, atom order matters as to which case is seen fist + // b/c I think in Tinker, which case is seen first can depend on atom order for (j = 0; j < nspecial[i][0]; j++) bondneigh[j] = special[i][j]; diff --git a/src/AMOEBA/fix_amoeba_bitorsion.cpp b/src/AMOEBA/fix_amoeba_bitorsion.cpp index 0996a37cfd..711ac7e05d 100644 --- a/src/AMOEBA/fix_amoeba_bitorsion.cpp +++ b/src/AMOEBA/fix_amoeba_bitorsion.cpp @@ -778,7 +778,7 @@ void FixAmoebaBiTorsion::read_grid_data(char *bitorsion_file) memory->create(tty[itype],ny,"bitorsion:tty"); memory->create(tbf[itype],nx*ny,"bitorsion:tbf"); - // NOTE: should read this chunk of lines with utils in single read + // NOTE: could read this chunk of lines with utils in single read? if (me == 0) { for (int iy = 0; iy < ny; iy++) { diff --git a/src/AMOEBA/pair_amoeba.cpp b/src/AMOEBA/pair_amoeba.cpp index 4dd8ba16be..be5f9c73df 100644 --- a/src/AMOEBA/pair_amoeba.cpp +++ b/src/AMOEBA/pair_amoeba.cpp @@ -552,11 +552,14 @@ void PairAmoeba::allocate() /* ---------------------------------------------------------------------- global settings + NOTE: these undocumented args are only for debugging ------------------------------------------------------------------------- */ void PairAmoeba::settings(int narg, char **arg) { // turn on all FF components by default + // first 4 lines are non-bonded terms + // last 2 lines are bonded terms hal_flag = repulse_flag = qxfer_flag = 1; disp_rspace_flag = disp_kspace_flag = 1; @@ -616,6 +619,12 @@ void PairAmoeba::settings(int narg, char **arg) else if (strcmp(arg[iarg],"bitorsion") == 0) bitorsion_flag = newvalue; else error->all(FLERR,"Illegal pair_style command"); } + + // cannot disable bond and dihedral terms b/c those classes not in AMOEBA pkg + + if ((bond_flag == 0 || dihedral_flag == 0) && comm->me == 0) + error->warning(FLERR,"Cannot disable AMOEBA bonds or dihedrals - " + "use bond_style or dihedral_style none instead"); } /* ---------------------------------------------------------------------- @@ -1757,7 +1766,7 @@ void PairAmoeba::precond_neigh() // rather all interactions in the precond neigh list are // used every step until the neighbor list is rebuilt, // this means the cutoff distance is not exactly enforced, - // on a later step atoms outside may contribute, atoms inside may not + // on later steps atoms outside may contribute, atoms inside may not choose(USOLV); @@ -2067,6 +2076,7 @@ void *PairAmoeba::extract(const char *str, int &dim) if (strcmp(str,"opbend_quartic") == 0) return (void *) &opbend_quartic; if (strcmp(str,"opbend_pentic") == 0) return (void *) &opbend_pentic; if (strcmp(str,"opbend_sextic") == 0) return (void *) &opbend_sextic; + return nullptr; } diff --git a/src/CLASS2/bond_class2.cpp b/src/CLASS2/bond_class2.cpp index 79d1484768..8aec47c394 100644 --- a/src/CLASS2/bond_class2.cpp +++ b/src/CLASS2/bond_class2.cpp @@ -53,8 +53,6 @@ BondClass2::~BondClass2() void BondClass2::compute(int eflag, int vflag) { - if (disable) return; - int i1,i2,n,type; double delx,dely,delz,ebond,fbond; double rsq,r,dr,dr2,dr3,dr4,de_bond; @@ -157,24 +155,6 @@ void BondClass2::coeff(int narg, char **arg) if (count == 0) error->all(FLERR,"Incorrect args for bond coefficients"); } -/* ---------------------------------------------------------------------- */ - -void BondClass2::init_style() -{ - // check if PairAmoeba or PairHippo disabled bond terms - - Pair *pair = NULL; - pair = force->pair_match("amoeba",1,0); - if (!pair) pair = force->pair_match("hippo",1,0); - - if (!pair) disable = 0; - else { - int tmp; - int flag = *((int *) pair->extract("bond_flag",tmp)); - disable = flag ? 0 : 1; - } -} - /* ---------------------------------------------------------------------- return an equilbrium bond length ------------------------------------------------------------------------- */ diff --git a/src/CLASS2/bond_class2.h b/src/CLASS2/bond_class2.h index 799ac8ca5f..1ca65a8628 100644 --- a/src/CLASS2/bond_class2.h +++ b/src/CLASS2/bond_class2.h @@ -30,7 +30,6 @@ class BondClass2 : public Bond { ~BondClass2() override; void compute(int, int) override; void coeff(int, char **) override; - void init_style() override; double equilibrium_distance(int) override; void write_restart(FILE *) override; void read_restart(FILE *) override; @@ -40,7 +39,6 @@ class BondClass2 : public Bond { protected: double *r0, *k2, *k3, *k4; - int disable; void allocate(); }; diff --git a/src/EXTRA-MOLECULE/dihedral_fourier.cpp b/src/EXTRA-MOLECULE/dihedral_fourier.cpp index 625a9b8e31..666b5e91a1 100644 --- a/src/EXTRA-MOLECULE/dihedral_fourier.cpp +++ b/src/EXTRA-MOLECULE/dihedral_fourier.cpp @@ -69,8 +69,6 @@ DihedralFourier::~DihedralFourier() void DihedralFourier::compute(int eflag, int vflag) { - if (disable) return; - int i1,i2,i3,i4,i,j,m,n,type; double vb1x,vb1y,vb1z,vb2x,vb2y,vb2z,vb3x,vb3y,vb3z,vb2xm,vb2ym,vb2zm; double edihedral,f1[3],f2[3],f3[3],f4[3]; @@ -328,24 +326,6 @@ void DihedralFourier::coeff(int narg, char **arg) if (count == 0) error->all(FLERR,"Incorrect args for dihedral coefficients"); } -/* ---------------------------------------------------------------------- */ - -void DihedralFourier::init_style() -{ - // check if PairAmoeba or PairHippo disabled dihedral terms - - Pair *pair = NULL; - pair = force->pair_match("amoeba",1,0); - if (!pair) pair = force->pair_match("hippo",1,0); - - if (!pair) disable = 0; - else { - int tmp; - int flag = *((int *) pair->extract("dihedral_flag",tmp)); - disable = flag ? 0 : 1; - } -} - /* ---------------------------------------------------------------------- proc 0 writes out coeffs to restart file ------------------------------------------------------------------------- */ diff --git a/src/EXTRA-MOLECULE/dihedral_fourier.h b/src/EXTRA-MOLECULE/dihedral_fourier.h index 660e5083aa..18116af25c 100644 --- a/src/EXTRA-MOLECULE/dihedral_fourier.h +++ b/src/EXTRA-MOLECULE/dihedral_fourier.h @@ -30,7 +30,6 @@ class DihedralFourier : public Dihedral { ~DihedralFourier() override; void compute(int, int) override; void coeff(int, char **) override; - void init_style() override; void write_restart(FILE *) override; void read_restart(FILE *) override; void write_data(FILE *) override; @@ -40,7 +39,6 @@ class DihedralFourier : public Dihedral { int **multiplicity; int *nterms; int implicit, weightflag; - int disable; void allocate(); }; From b2b0704648403fe31203d85db883fd87ee632231 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Thu, 7 Jul 2022 15:01:55 -0600 Subject: [PATCH 545/585] new log files --- examples/amoeba/log.7Jul22.ubiquitin.g++.1 | 163 ++++++++++++++++++ examples/amoeba/log.7Jul22.ubiquitin.g++.4 | 163 ++++++++++++++++++ .../amoeba/log.7Jul22.water_box.amoeba.g++.1 | 146 ++++++++++++++++ .../amoeba/log.7Jul22.water_box.amoeba.g++.4 | 146 ++++++++++++++++ .../amoeba/log.7Jul22.water_box.hippo.g++.1 | 150 ++++++++++++++++ .../amoeba/log.7Jul22.water_box.hippo.g++.4 | 150 ++++++++++++++++ .../log.7Jul22.water_dimer.amoeba.g++.1 | 147 ++++++++++++++++ .../log.7Jul22.water_dimer.amoeba.g++.4 | 147 ++++++++++++++++ .../amoeba/log.7Jul22.water_dimer.hippo.g++.1 | 151 ++++++++++++++++ .../amoeba/log.7Jul22.water_dimer.hippo.g++.4 | 151 ++++++++++++++++ .../log.7Jul22.water_hexamer.amoeba.g++.1 | 146 ++++++++++++++++ .../log.7Jul22.water_hexamer.amoeba.g++.4 | 147 ++++++++++++++++ .../log.7Jul22.water_hexamer.hippo.g++.1 | 150 ++++++++++++++++ .../log.7Jul22.water_hexamer.hippo.g++.4 | 151 ++++++++++++++++ 14 files changed, 2108 insertions(+) create mode 100644 examples/amoeba/log.7Jul22.ubiquitin.g++.1 create mode 100644 examples/amoeba/log.7Jul22.ubiquitin.g++.4 create mode 100644 examples/amoeba/log.7Jul22.water_box.amoeba.g++.1 create mode 100644 examples/amoeba/log.7Jul22.water_box.amoeba.g++.4 create mode 100644 examples/amoeba/log.7Jul22.water_box.hippo.g++.1 create mode 100644 examples/amoeba/log.7Jul22.water_box.hippo.g++.4 create mode 100644 examples/amoeba/log.7Jul22.water_dimer.amoeba.g++.1 create mode 100644 examples/amoeba/log.7Jul22.water_dimer.amoeba.g++.4 create mode 100644 examples/amoeba/log.7Jul22.water_dimer.hippo.g++.1 create mode 100644 examples/amoeba/log.7Jul22.water_dimer.hippo.g++.4 create mode 100644 examples/amoeba/log.7Jul22.water_hexamer.amoeba.g++.1 create mode 100644 examples/amoeba/log.7Jul22.water_hexamer.amoeba.g++.4 create mode 100644 examples/amoeba/log.7Jul22.water_hexamer.hippo.g++.1 create mode 100644 examples/amoeba/log.7Jul22.water_hexamer.hippo.g++.4 diff --git a/examples/amoeba/log.7Jul22.ubiquitin.g++.1 b/examples/amoeba/log.7Jul22.ubiquitin.g++.1 new file mode 100644 index 0000000000..d10a114126 --- /dev/null +++ b/examples/amoeba/log.7Jul22.ubiquitin.g++.1 @@ -0,0 +1,163 @@ +LAMMPS (23 Jun 2022) +# solvated ubiquitin molecule with AMOEBA force field + +units real +boundary p p p +atom_modify sort 0 0.0 + +atom_style amoeba + +bond_style class2 +angle_style amoeba +dihedral_style fourier +improper_style amoeba + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 + +fix pit all amoeba/pitorsion +fix_modify pit energy yes +fix bit all amoeba/bitorsion bitorsion.ubiquitin.data +fix_modify bit energy yes + +# read data file + +read_data data.ubiquitin fix amtype NULL "Tinker Types" fix pit "pitorsion types" "PiTorsion Coeffs" fix pit pitorsions PiTorsions fix bit bitorsions BiTorsions +Reading data file ... + orthogonal box = (0 0 0) to (54.99 41.91 41.91) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 9737 atoms + scanning bonds ... + 4 = max bonds/atom + scanning angles ... + 6 = max angles/atom + scanning dihedrals ... + 18 = max dihedrals/atom + scanning impropers ... + 3 = max impropers/atom + reading bonds ... + 6908 bonds + reading angles ... + 5094 angles + reading dihedrals ... + 3297 dihedrals + reading impropers ... + 651 impropers +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 4 = max # of 1-2 neighbors + 9 = max # of 1-3 neighbors + 19 = max # of 1-4 neighbors + 21 = max # of special neighbors + special bonds CPU = 0.004 seconds + read_data CPU = 0.091 seconds + +pair_style amoeba +pair_coeff * * amoeba_ubiquitin.prm amoeba_ubiquitin.key +Reading potential file amoeba_ubiquitin.prm with DATE: 2022-07-05 +Skipping section: AMOEBA Protein Force Field Atom Classes +Skipping section: Torsion-Torsion Parameters +Skipping section: Biopolymer Atom Type Conversions +Reading potential file amoeba_ubiquitin.key with DATE: 2022-07-05 + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0.5 0.5 0.5 + special bond factors coul: 0.5 0.5 0.5 + 4 = max # of 1-2 neighbors + 9 = max # of 1-3 neighbors + 19 = max # of 1-4 neighbors + 58 = max # of 1-5 neighbors + 21 = max # of special neighbors + special bonds CPU = 0.007 seconds + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] + +#dump 1 all custom 10 dump.ubiquitin id type x y z fx fy fz +#dump_modify 1 sort id + +# dynamics + +fix 1 all nve + +thermo 1 +run 10 +AMOEBA force field settings + hal: cut 12 taper 10.8 vscale 0 0 1 1 + multipole: cut 7 aewald 0.4 bsorder 5 FFT 60 48 48 mscale 0 0 0.4 1 + polar: cut 7 aewald 0.5 bsorder 5 FFT 60 48 48 + pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 1 1 1 1 d/u scale 0 1 + precondition: cut 4.5 +Generated 0 of 15 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 14 + ghost atom cutoff = 14 + binsize = 7, bins = 8 6 6 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair amoeba, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d + bin: standard + AMOEBA group count: 3196 +Per MPI rank memory allocation (min/avg/max) = 258.3 | 258.3 | 258.3 Mbytes + Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] + 0 0 -35338.057 2856.5938 1955.5431 224.37609 65.00809 5101.5211 -30247.585 -6336.5196 -5795.4272 -6329.8149 -6884.3167 349.52657 77.164877 652.41925 + 1 29.61379 -35356.153 2037.3541 1840.7883 223.90217 64.293945 4166.3385 -30341.522 -6486.773 -6452.8463 -6841.5982 -7386.1106 311.38025 120.72605 545.35513 + 2 78.518242 -35383.65 825.39919 1538.3909 222.55095 62.191009 2648.5321 -30467.814 -5502.9841 -6410.2998 -6396.1829 -6937.8137 217.3515 210.76948 294.28051 + 3 88.8921 -35402.11 938.99299 1162.2914 220.5271 58.832521 2380.644 -30453.516 -1929.5417 -3331.1291 -2769.7218 -3350.5733 117.32302 279.72705 31.237776 + 4 68.740402 -35477.589 2048.0659 858.03795 218.14277 54.460022 3178.7066 -30316.325 2041.1138 594.25938 1665.7799 1030.8539 66.230421 304.28296 -155.80224 + 5 76.267862 -35707.869 2206.6534 736.37385 215.75693 49.401674 3208.1859 -30299.377 2276.9276 536.21124 1893.4621 1258.492 92.097191 299.65604 -228.58369 + 6 118.24373 -36092.77 1166.179 815.59206 213.67399 44.022297 2239.4673 -30435.629 -1677.8051 -3988.2428 -2669.6848 -3247.7207 197.42472 285.87129 -162.35459 + 7 137.7204 -36521.444 782.87113 1026.745 212.04289 38.686259 2060.3452 -30479.082 -5987.83 -8386.8104 -7363.188 -7888.261 357.00835 253.66346 32.827786 + 8 112.66452 -36897.181 1750.0569 1269.152 210.83571 33.742799 3263.7874 -30379.432 -7886.4081 -9703.2601 -9043.015 -9555.2908 490.76046 182.31259 278.727 + 9 88.237359 -37209.906 2695.1766 1454.55 209.91331 29.503458 4389.1434 -30276.565 -8202.16 -9492.368 -9110.7037 -9639.2288 502.55699 107.82333 443.6705 + 10 108.86756 -37474.988 2240.4603 1523.7936 209.10313 26.208515 3999.5656 -30333.279 -8468.4347 -9956.923 -9709.5874 -10224.682 365.98214 95.262991 425.12746 +Loop time of 24.2102 on 1 procs for 10 steps with 9737 atoms + +Performance: 0.036 ns/day, 672.507 hours/ns, 0.413 timesteps/s +97.8% CPU use with 1 MPI tasks x no OpenMP threads + +AMOEBA timing breakdown: + Init time: 0.0401664 0.17% + Hal time: 7.62094 31.51% + Mpole time: 2.44622 10.12% + Induce time: 9.28925 38.41% + Polar time: 4.78631 19.79% + Total time: 24.1829 + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 24.183 | 24.183 | 24.183 | 0.0 | 99.89 +Bond | 0.016031 | 0.016031 | 0.016031 | 0.0 | 0.07 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.004396 | 0.004396 | 0.004396 | 0.0 | 0.02 +Output | 0.0011692 | 0.0011692 | 0.0011692 | 0.0 | 0.00 +Modify | 0.0044765 | 0.0044765 | 0.0044765 | 0.0 | 0.02 +Other | | 0.001194 | | | 0.00 + +Nlocal: 9737 ave 9737 max 9737 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 31511 ave 31511 max 31511 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 5.6393e+06 ave 5.6393e+06 max 5.6393e+06 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 5639296 +Ave neighs/atom = 579.16155 +Ave special neighs/atom = 3.1364897 +Neighbor list builds = 0 +Dangerous builds = 0 +Total wall time: 0:00:27 diff --git a/examples/amoeba/log.7Jul22.ubiquitin.g++.4 b/examples/amoeba/log.7Jul22.ubiquitin.g++.4 new file mode 100644 index 0000000000..50bbd6ce03 --- /dev/null +++ b/examples/amoeba/log.7Jul22.ubiquitin.g++.4 @@ -0,0 +1,163 @@ +LAMMPS (23 Jun 2022) +# solvated ubiquitin molecule with AMOEBA force field + +units real +boundary p p p +atom_modify sort 0 0.0 + +atom_style amoeba + +bond_style class2 +angle_style amoeba +dihedral_style fourier +improper_style amoeba + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 + +fix pit all amoeba/pitorsion +fix_modify pit energy yes +fix bit all amoeba/bitorsion bitorsion.ubiquitin.data +fix_modify bit energy yes + +# read data file + +read_data data.ubiquitin fix amtype NULL "Tinker Types" fix pit "pitorsion types" "PiTorsion Coeffs" fix pit pitorsions PiTorsions fix bit bitorsions BiTorsions +Reading data file ... + orthogonal box = (0 0 0) to (54.99 41.91 41.91) + 2 by 1 by 2 MPI processor grid + reading atoms ... + 9737 atoms + scanning bonds ... + 4 = max bonds/atom + scanning angles ... + 6 = max angles/atom + scanning dihedrals ... + 18 = max dihedrals/atom + scanning impropers ... + 3 = max impropers/atom + reading bonds ... + 6908 bonds + reading angles ... + 5094 angles + reading dihedrals ... + 3297 dihedrals + reading impropers ... + 651 impropers +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 4 = max # of 1-2 neighbors + 9 = max # of 1-3 neighbors + 19 = max # of 1-4 neighbors + 21 = max # of special neighbors + special bonds CPU = 0.001 seconds + read_data CPU = 0.072 seconds + +pair_style amoeba +pair_coeff * * amoeba_ubiquitin.prm amoeba_ubiquitin.key +Reading potential file amoeba_ubiquitin.prm with DATE: 2022-07-05 +Skipping section: AMOEBA Protein Force Field Atom Classes +Skipping section: Torsion-Torsion Parameters +Skipping section: Biopolymer Atom Type Conversions +Reading potential file amoeba_ubiquitin.key with DATE: 2022-07-05 + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0.5 0.5 0.5 + special bond factors coul: 0.5 0.5 0.5 + 4 = max # of 1-2 neighbors + 9 = max # of 1-3 neighbors + 19 = max # of 1-4 neighbors + 58 = max # of 1-5 neighbors + 21 = max # of special neighbors + special bonds CPU = 0.002 seconds + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] + +#dump 1 all custom 10 dump.ubiquitin id type x y z fx fy fz +#dump_modify 1 sort id + +# dynamics + +fix 1 all nve + +thermo 1 +run 10 +AMOEBA force field settings + hal: cut 12 taper 10.8 vscale 0 0 1 1 + multipole: cut 7 aewald 0.4 bsorder 5 FFT 60 48 48 mscale 0 0 0.4 1 + polar: cut 7 aewald 0.5 bsorder 5 FFT 60 48 48 + pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 1 1 1 1 d/u scale 0 1 + precondition: cut 4.5 +Generated 0 of 15 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 14 + ghost atom cutoff = 14 + binsize = 7, bins = 8 6 6 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair amoeba, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d + bin: standard + AMOEBA group count: 3196 +Per MPI rank memory allocation (min/avg/max) = 144.2 | 144.7 | 145.4 Mbytes + Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] + 0 0 -35338.057 2856.5938 1955.5431 224.37609 65.00809 5101.5211 -30247.585 -6336.5196 -5795.4272 -6329.8149 -6884.3167 349.52657 77.164877 652.41925 + 1 29.61379 -35356.153 2037.3541 1840.7883 223.90217 64.293945 4166.3385 -30341.522 -6486.773 -6452.8463 -6841.5982 -7386.1106 311.38025 120.72605 545.35513 + 2 78.518242 -35383.65 825.39919 1538.3909 222.55095 62.191009 2648.5321 -30467.814 -5502.9841 -6410.2998 -6396.1829 -6937.8137 217.3515 210.76948 294.28051 + 3 88.8921 -35402.11 938.99299 1162.2914 220.5271 58.832521 2380.644 -30453.516 -1929.5417 -3331.1291 -2769.7218 -3350.5733 117.32302 279.72705 31.237776 + 4 68.740402 -35477.589 2048.0659 858.03795 218.14277 54.460022 3178.7066 -30316.325 2041.1138 594.25938 1665.7799 1030.8539 66.230421 304.28296 -155.80224 + 5 76.267862 -35707.869 2206.6534 736.37385 215.75693 49.401674 3208.1859 -30299.377 2276.9276 536.21124 1893.4621 1258.492 92.097191 299.65604 -228.58369 + 6 118.24373 -36092.77 1166.179 815.59206 213.67399 44.022297 2239.4673 -30435.629 -1677.8051 -3988.2428 -2669.6848 -3247.7207 197.42472 285.87129 -162.35459 + 7 137.7204 -36521.444 782.87113 1026.745 212.04289 38.686259 2060.3452 -30479.082 -5987.83 -8386.8104 -7363.188 -7888.261 357.00835 253.66346 32.827786 + 8 112.66452 -36897.181 1750.0569 1269.152 210.83571 33.742799 3263.7874 -30379.432 -7886.4081 -9703.2601 -9043.015 -9555.2908 490.76046 182.31259 278.727 + 9 88.237359 -37209.906 2695.1766 1454.55 209.91331 29.503458 4389.1434 -30276.565 -8202.16 -9492.368 -9110.7037 -9639.2288 502.55699 107.82333 443.6705 + 10 108.86756 -37474.988 2240.4603 1523.7936 209.10313 26.208515 3999.5656 -30333.279 -8468.4347 -9956.923 -9709.5874 -10224.682 365.98214 95.262991 425.12746 +Loop time of 6.03244 on 4 procs for 10 steps with 9737 atoms + +Performance: 0.143 ns/day, 167.568 hours/ns, 1.658 timesteps/s +99.7% CPU use with 4 MPI tasks x no OpenMP threads + +AMOEBA timing breakdown: + Init time: 0.0192504 0.32% + Hal time: 1.86975 31.05% + Mpole time: 0.633256 10.52% + Induce time: 2.26029 37.54% + Polar time: 1.23884 20.57% + Total time: 6.02139 + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 6.0202 | 6.0215 | 6.0228 | 0.0 | 99.82 +Bond | 0.0029895 | 0.0033805 | 0.0036579 | 0.4 | 0.06 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.0044978 | 0.0059188 | 0.0070446 | 1.5 | 0.10 +Output | 0.00055049 | 0.00062352 | 0.00079826 | 0.0 | 0.01 +Modify | 0.00067451 | 0.00071394 | 0.00074612 | 0.0 | 0.01 +Other | | 0.0003294 | | | 0.01 + +Nlocal: 2434.25 ave 2498 max 2390 min +Histogram: 1 1 0 0 1 0 0 0 0 1 +Nghost: 16683.2 ave 16765 max 16568 min +Histogram: 1 0 0 1 0 0 0 0 0 2 +Neighs: 1.40982e+06 ave 1.52088e+06 max 1.30717e+06 min +Histogram: 2 0 0 0 0 0 0 0 1 1 + +Total # of neighbors = 5639296 +Ave neighs/atom = 579.16155 +Ave special neighs/atom = 3.1364897 +Neighbor list builds = 0 +Dangerous builds = 0 +Total wall time: 0:00:07 diff --git a/examples/amoeba/log.7Jul22.water_box.amoeba.g++.1 b/examples/amoeba/log.7Jul22.water_box.amoeba.g++.1 new file mode 100644 index 0000000000..f0b1ed83e5 --- /dev/null +++ b/examples/amoeba/log.7Jul22.water_box.amoeba.g++.1 @@ -0,0 +1,146 @@ +LAMMPS (23 Jun 2022) +# replicate water box with AMOEBA or HIPPO + +units real +boundary p p p + +atom_style amoeba +bond_style class2 +angle_style amoeba +dihedral_style none + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 + +# read data file + +read_data data.water_box.amoeba fix amtype NULL "Tinker Types" +Reading data file ... + orthogonal box = (0 0 0) to (18.643 18.643 18.643) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 648 atoms + scanning bonds ... + 2 = max bonds/atom + scanning angles ... + 1 = max angles/atom + reading bonds ... + 432 bonds + reading angles ... + 216 angles +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + read_data CPU = 0.010 seconds + +# force field + +pair_style amoeba +pair_coeff * * amoeba_water.prm amoeba_water_box.key +Reading potential file amoeba_water.prm with DATE: 2022-07-05 +Reading potential file amoeba_water_box.key with DATE: 2022-07-05 + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0.5 0.5 0.5 + special bond factors coul: 0.5 0.5 0.5 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of 1-5 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.001 seconds + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] + +#dump 1 all custom 10 dump.water_box id type x y z fx fy fz +#dump_modify 1 sort id + +# dynamics + +fix 1 all nve + +thermo 10 +run 100 +AMOEBA force field settings + hal: cut 7 taper 6 vscale 0 0 1 1 + multipole: cut 7 aewald 0.4 bsorder 5 FFT 24 24 24 mscale 0 0 0.4 1 + polar: cut 7 aewald 0.5 bsorder 5 FFT 24 24 24 + pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 1 1 1 1 d/u scale 0 1 + precondition: cut 4.5 +Generated 0 of 1 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 9 + ghost atom cutoff = 9 + binsize = 4.5, bins = 5 5 5 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair amoeba, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d + bin: standard + AMOEBA group count: 216 +Per MPI rank memory allocation (min/avg/max) = 56.94 | 56.94 | 56.94 Mbytes + Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] + 0 0 -2172.0637 166.82637 83.732524 0 0 250.5589 -1921.5048 -6181.4178 -4772.1682 -6954.8414 -6817.2437 -272.19967 3173.3481 2229.9454 + 10 105.50186 -2373.7036 136.67877 106.86833 0 0 243.5471 -1926.6873 -8440.8076 -10450.396 -9513.7369 -9664.6007 -301.7395 322.28511 1917.0314 + 20 143.89822 -2358.363 70.950306 76.775658 0 0 147.72596 -1933.1172 -7370.2083 -7728.5515 -11580.39 -8675.2341 -806.78779 780.67516 2096.34 + 30 157.22465 -2375.4739 50.393531 87.108003 0 0 137.50153 -1934.7514 -4449.577 -6946.7795 -7865.2165 -4954.2358 -417.69587 -1004.2877 -36.388669 + 40 150.92481 -2354.1892 78.482464 53.798462 0 0 132.28093 -1930.8371 353.42948 -939.14353 -4636.5062 475.58057 -1073.8523 -1583.9471 -574.21807 + 50 153.0181 -2388.7322 100.20232 65.813823 0 0 166.01614 -1927.6078 3975.1981 1368.1361 425.64533 3886.0124 -1806.8586 -2534.5272 -2118.2395 + 60 155.01494 -2364.3168 92.946192 44.248949 0 0 137.19514 -1928.1623 5793.7546 3524.7523 1420.4096 6108.7958 -1536.5261 -2558.8204 -1501.5292 + 70 166.70755 -2383.503 76.491199 55.01988 0 0 131.51108 -1930.4824 4744.1583 1919.3954 2838.7666 2669.745 -169.21643 -188.08678 -2256.4142 + 80 171.83506 -2388.0612 76.465932 49.1299 0 0 125.59583 -1931.067 2210.3658 -318.23867 330.74353 -395.26693 -43.142216 252.53012 -1987.0412 + 90 175.73401 -2423.8154 90.786573 63.719496 0 0 154.50607 -1930.3915 -916.91571 -3942.3954 -2566.5361 -3414.8202 199.82369 2365.9443 -266.38604 + 100 173.72684 -2422.367 99.75941 57.294464 0 0 157.05387 -1930.2663 -3585.8356 -5734.1341 -5882.0146 -6232.4353 -227.79935 959.68225 404.47924 +Loop time of 14.5572 on 1 procs for 100 steps with 648 atoms + +Performance: 0.594 ns/day, 40.437 hours/ns, 6.869 timesteps/s +99.9% CPU use with 1 MPI tasks x no OpenMP threads + +AMOEBA timing breakdown: + Init time: 0.0224497 0.15% + Hal time: 1.00248 6.90% + Mpole time: 1.42229 9.78% + Induce time: 9.23983 63.55% + Polar time: 2.8515 19.61% + Total time: 14.5386 + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 14.539 | 14.539 | 14.539 | 0.0 | 99.87 +Bond | 0.0029302 | 0.0029302 | 0.0029302 | 0.0 | 0.02 +Neigh | 0.010789 | 0.010789 | 0.010789 | 0.0 | 0.07 +Comm | 0.0027888 | 0.0027888 | 0.0027888 | 0.0 | 0.02 +Output | 0.00040039 | 0.00040039 | 0.00040039 | 0.0 | 0.00 +Modify | 0.0007305 | 0.0007305 | 0.0007305 | 0.0 | 0.01 +Other | | 0.0008703 | | | 0.01 + +Nlocal: 648 ave 648 max 648 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 4290 ave 4290 max 4290 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 98545 ave 98545 max 98545 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 98545 +Ave neighs/atom = 152.07562 +Ave special neighs/atom = 2 +Neighbor list builds = 2 +Dangerous builds = 0 +Total wall time: 0:00:14 diff --git a/examples/amoeba/log.7Jul22.water_box.amoeba.g++.4 b/examples/amoeba/log.7Jul22.water_box.amoeba.g++.4 new file mode 100644 index 0000000000..f813feadb9 --- /dev/null +++ b/examples/amoeba/log.7Jul22.water_box.amoeba.g++.4 @@ -0,0 +1,146 @@ +LAMMPS (23 Jun 2022) +# replicate water box with AMOEBA or HIPPO + +units real +boundary p p p + +atom_style amoeba +bond_style class2 +angle_style amoeba +dihedral_style none + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 + +# read data file + +read_data data.water_box.amoeba fix amtype NULL "Tinker Types" +Reading data file ... + orthogonal box = (0 0 0) to (18.643 18.643 18.643) + 1 by 2 by 2 MPI processor grid + reading atoms ... + 648 atoms + scanning bonds ... + 2 = max bonds/atom + scanning angles ... + 1 = max angles/atom + reading bonds ... + 432 bonds + reading angles ... + 216 angles +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.001 seconds + read_data CPU = 0.011 seconds + +# force field + +pair_style amoeba +pair_coeff * * amoeba_water.prm amoeba_water_box.key +Reading potential file amoeba_water.prm with DATE: 2022-07-05 +Reading potential file amoeba_water_box.key with DATE: 2022-07-05 + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0.5 0.5 0.5 + special bond factors coul: 0.5 0.5 0.5 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of 1-5 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.001 seconds + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] + +#dump 1 all custom 10 dump.water_box id type x y z fx fy fz +#dump_modify 1 sort id + +# dynamics + +fix 1 all nve + +thermo 10 +run 100 +AMOEBA force field settings + hal: cut 7 taper 6 vscale 0 0 1 1 + multipole: cut 7 aewald 0.4 bsorder 5 FFT 24 24 24 mscale 0 0 0.4 1 + polar: cut 7 aewald 0.5 bsorder 5 FFT 24 24 24 + pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 1 1 1 1 d/u scale 0 1 + precondition: cut 4.5 +Generated 0 of 1 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 9 + ghost atom cutoff = 9 + binsize = 4.5, bins = 5 5 5 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair amoeba, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d + bin: standard + AMOEBA group count: 216 +Per MPI rank memory allocation (min/avg/max) = 56.38 | 56.38 | 56.38 Mbytes + Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] + 0 0 -2172.0637 166.82637 83.732524 0 0 250.5589 -1921.5048 -6181.4178 -4772.1682 -6954.8414 -6817.2437 -272.19967 3173.3481 2229.9454 + 10 105.50186 -2373.7036 136.67877 106.86833 0 0 243.5471 -1926.6873 -8440.8076 -10450.396 -9513.7369 -9664.6007 -301.7395 322.28511 1917.0314 + 20 143.89822 -2358.363 70.950306 76.775658 0 0 147.72596 -1933.1172 -7370.2083 -7728.5515 -11580.39 -8675.2341 -806.78779 780.67516 2096.34 + 30 157.22465 -2375.4739 50.393531 87.108003 0 0 137.50153 -1934.7514 -4449.577 -6946.7795 -7865.2165 -4954.2358 -417.69587 -1004.2877 -36.388669 + 40 150.92481 -2354.1892 78.482464 53.798462 0 0 132.28093 -1930.8371 353.42948 -939.14353 -4636.5062 475.58057 -1073.8523 -1583.9471 -574.21807 + 50 153.0181 -2388.7322 100.20232 65.813823 0 0 166.01614 -1927.6078 3975.1981 1368.1361 425.64533 3886.0124 -1806.8586 -2534.5272 -2118.2395 + 60 155.01494 -2364.3168 92.946192 44.248949 0 0 137.19514 -1928.1623 5793.7546 3524.7523 1420.4096 6108.7958 -1536.5261 -2558.8204 -1501.5292 + 70 166.70755 -2383.503 76.491199 55.01988 0 0 131.51108 -1930.4824 4744.1583 1919.3954 2838.7666 2669.745 -169.21643 -188.08678 -2256.4142 + 80 171.83506 -2388.0612 76.465932 49.1299 0 0 125.59583 -1931.067 2210.3658 -318.23867 330.74353 -395.26693 -43.142216 252.53012 -1987.0412 + 90 175.73401 -2423.8154 90.786573 63.719496 0 0 154.50607 -1930.3915 -916.91571 -3942.3954 -2566.5361 -3414.8202 199.82369 2365.9443 -266.38604 + 100 173.72684 -2422.367 99.75941 57.294464 0 0 157.05387 -1930.2663 -3585.8356 -5734.1341 -5882.0146 -6232.4353 -227.79935 959.68225 404.47924 +Loop time of 5.22237 on 4 procs for 100 steps with 648 atoms + +Performance: 1.654 ns/day, 14.507 hours/ns, 19.148 timesteps/s +100.0% CPU use with 4 MPI tasks x no OpenMP threads + +AMOEBA timing breakdown: + Init time: 0.0217547 0.42% + Hal time: 0.246901 4.74% + Mpole time: 0.489975 9.41% + Induce time: 3.54999 68.15% + Polar time: 0.900374 17.28% + Total time: 5.20901 + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 5.2084 | 5.2093 | 5.2114 | 0.1 | 99.75 +Bond | 0.00074127 | 0.00080769 | 0.00084525 | 0.0 | 0.02 +Neigh | 0.0014801 | 0.001481 | 0.0014832 | 0.0 | 0.03 +Comm | 0.007438 | 0.0095884 | 0.010526 | 1.3 | 0.18 +Output | 0.00028866 | 0.00033051 | 0.00044509 | 0.0 | 0.01 +Modify | 0.00020399 | 0.00020969 | 0.00021248 | 0.0 | 0.00 +Other | | 0.000658 | | | 0.01 + +Nlocal: 162 ave 164 max 159 min +Histogram: 1 0 0 0 0 0 1 0 1 1 +Nghost: 2568.5 ave 2585 max 2544 min +Histogram: 1 0 0 0 0 1 0 0 1 1 +Neighs: 24636.2 ave 25226 max 23891 min +Histogram: 1 0 0 0 0 0 2 0 0 1 + +Total # of neighbors = 98545 +Ave neighs/atom = 152.07562 +Ave special neighs/atom = 2 +Neighbor list builds = 2 +Dangerous builds = 0 +Total wall time: 0:00:05 diff --git a/examples/amoeba/log.7Jul22.water_box.hippo.g++.1 b/examples/amoeba/log.7Jul22.water_box.hippo.g++.1 new file mode 100644 index 0000000000..0c4d2a2ebf --- /dev/null +++ b/examples/amoeba/log.7Jul22.water_box.hippo.g++.1 @@ -0,0 +1,150 @@ +LAMMPS (23 Jun 2022) +# water box with AMOEBA or HIPPO + +units real +boundary p p p + +atom_style amoeba +bond_style class2 +angle_style amoeba +dihedral_style none + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 + +# read data file + +read_data data.water_box.hippo fix amtype NULL "Tinker Types" +Reading data file ... + orthogonal box = (0 0 0) to (18.643 18.643 18.643) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 648 atoms + scanning bonds ... + 2 = max bonds/atom + scanning angles ... + 1 = max angles/atom + reading bonds ... + 432 bonds + reading angles ... + 216 angles +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + read_data CPU = 0.011 seconds + +# force field + +pair_style hippo +pair_coeff * * hippo_water.prm hippo_water_box.key +Reading potential file hippo_water.prm with DATE: 2022-07-05 +Reading potential file hippo_water_box.key with DATE: 2022-07-05 + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0.5 0.5 0.5 + special bond factors coul: 0.5 0.5 0.5 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of 1-5 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.001 seconds + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] + +#dump 1 all custom 10 dump.water_box id type x y z fx fy fz +#dump_modify 1 sort id + +# dynamics + +fix 1 all nve + +thermo 10 +run 100 +HIPPO force field settings + repulsion: cut 7 taper 6 rscale 0 0 1 1 + qxfer: cut 7 taper 6 mscale 0 0 0.4 1 + dispersion: cut 7 aewald 0.45 bsorder 4 FFT 16 16 16 dspscale 0 0 0.4 1 + multipole: cut 7 aewald 0.4 bsorder 5 FFT 24 24 24 mscale 0 0 0.4 1 + polar: cut 7 aewald 0.5 bsorder 5 FFT 24 24 24 + pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 0.2 1 1 1 d/u scale 0 1 + precondition: cut 4.5 +Generated 0 of 1 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 9 + ghost atom cutoff = 9 + binsize = 4.5, bins = 5 5 5 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair hippo, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d + bin: standard + HIPPO group count: 216 +Per MPI rank memory allocation (min/avg/max) = 56.46 | 56.46 | 56.46 Mbytes + Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] + 0 0 -2188.594 166.82637 77.478353 0 0 244.30473 -1944.2893 -10859.589 -9285.4645 -11598.049 -11695.254 -282.7072 3164.4148 2495.2578 + 10 100.94691 -2350.192 116.13156 88.56605 0 0 204.69761 -1950.8098 -11480.919 -13574.139 -12190.797 -12798.212 -263.77028 280.62864 1974.1486 + 20 153.91622 -2358.3058 36.396961 66.22466 0 0 102.62162 -1958.8438 -7778.4529 -8492.3868 -11999.431 -9125.9998 -917.99962 589.09064 1788.2094 + 30 145.5951 -2343.9956 39.651541 65.833248 0 0 105.48479 -1957.7184 -288.79965 -2574.4466 -3820.4824 -414.28285 -347.51491 -1147.3995 -126.71025 + 40 126.87801 -2340.2623 102.93951 43.896946 0 0 146.83646 -1948.7309 6766.15 5908.7048 1280.0961 7930.8191 -1085.6811 -1596.6859 -714.82888 + 50 134.52078 -2358.9232 107.49288 44.253826 0 0 151.74671 -1947.7419 8762.4348 6023.4661 5377.0189 9396.0316 -1629.1364 -1663.1666 -2381.51 + 60 173.10181 -2374.3854 51.097314 33.03646 0 0 84.133774 -1956.4102 4614.2907 1719.1989 505.79149 4552.3167 -1661.1714 -587.92108 -1380.6732 + 70 184.86849 -2391.6106 39.916931 35.978152 0 0 75.895083 -1959.1811 -2146.9339 -4993.4021 -4095.6729 -4897.5768 -833.09046 1542.411 -1539.5266 + 80 164.75795 -2406.3017 101.94229 33.067832 0 0 135.01013 -1953.542 -8779.3265 -10545.409 -10418.702 -12098.858 -1319.194 1750.3511 -275.1272 + 90 151.17491 -2434.6876 152.21826 41.301673 0 0 193.51993 -1949.6141 -13330.691 -15436.505 -13791.461 -16934.674 149.25497 2289.1026 976.14333 + 100 166.99163 -2452.5298 143.57768 35.341459 0 0 178.91914 -1951.5533 -14918.51 -16077.49 -17353.738 -18140.466 19.009088 1487.0469 1084.0231 +Loop time of 9.10254 on 1 procs for 100 steps with 648 atoms + +Performance: 0.949 ns/day, 25.285 hours/ns, 10.986 timesteps/s +99.8% CPU use with 1 MPI tasks x no OpenMP threads + +HIPPO timing breakdown: + Init time: 0.0131104 0.14% + Repulse time: 1.06663 11.73% + Disp time: 0.585678 6.44% + Mpole time: 1.7162 18.88% + Induce time: 3.27504 36.03% + Polar time: 2.14366 23.58% + Qxfer time: 0.289804 3.19% + Total time: 9.09012 + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 9.0902 | 9.0902 | 9.0902 | 0.0 | 99.86 +Bond | 0.0024561 | 0.0024561 | 0.0024561 | 0.0 | 0.03 +Neigh | 0.005878 | 0.005878 | 0.005878 | 0.0 | 0.06 +Comm | 0.0023344 | 0.0023344 | 0.0023344 | 0.0 | 0.03 +Output | 0.00036107 | 0.00036107 | 0.00036107 | 0.0 | 0.00 +Modify | 0.00062368 | 0.00062368 | 0.00062368 | 0.0 | 0.01 +Other | | 0.0006736 | | | 0.01 + +Nlocal: 648 ave 648 max 648 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 4282 ave 4282 max 4282 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 98490 ave 98490 max 98490 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 98490 +Ave neighs/atom = 151.99074 +Ave special neighs/atom = 2 +Neighbor list builds = 2 +Dangerous builds = 0 +Total wall time: 0:00:09 diff --git a/examples/amoeba/log.7Jul22.water_box.hippo.g++.4 b/examples/amoeba/log.7Jul22.water_box.hippo.g++.4 new file mode 100644 index 0000000000..0cb1e8a934 --- /dev/null +++ b/examples/amoeba/log.7Jul22.water_box.hippo.g++.4 @@ -0,0 +1,150 @@ +LAMMPS (23 Jun 2022) +# water box with AMOEBA or HIPPO + +units real +boundary p p p + +atom_style amoeba +bond_style class2 +angle_style amoeba +dihedral_style none + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 + +# read data file + +read_data data.water_box.hippo fix amtype NULL "Tinker Types" +Reading data file ... + orthogonal box = (0 0 0) to (18.643 18.643 18.643) + 1 by 2 by 2 MPI processor grid + reading atoms ... + 648 atoms + scanning bonds ... + 2 = max bonds/atom + scanning angles ... + 1 = max angles/atom + reading bonds ... + 432 bonds + reading angles ... + 216 angles +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.001 seconds + read_data CPU = 0.013 seconds + +# force field + +pair_style hippo +pair_coeff * * hippo_water.prm hippo_water_box.key +Reading potential file hippo_water.prm with DATE: 2022-07-05 +Reading potential file hippo_water_box.key with DATE: 2022-07-05 + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0.5 0.5 0.5 + special bond factors coul: 0.5 0.5 0.5 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of 1-5 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.001 seconds + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] + +#dump 1 all custom 10 dump.water_box id type x y z fx fy fz +#dump_modify 1 sort id + +# dynamics + +fix 1 all nve + +thermo 10 +run 100 +HIPPO force field settings + repulsion: cut 7 taper 6 rscale 0 0 1 1 + qxfer: cut 7 taper 6 mscale 0 0 0.4 1 + dispersion: cut 7 aewald 0.45 bsorder 4 FFT 16 16 16 dspscale 0 0 0.4 1 + multipole: cut 7 aewald 0.4 bsorder 5 FFT 24 24 24 mscale 0 0 0.4 1 + polar: cut 7 aewald 0.5 bsorder 5 FFT 24 24 24 + pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 0.2 1 1 1 d/u scale 0 1 + precondition: cut 4.5 +Generated 0 of 1 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 9 + ghost atom cutoff = 9 + binsize = 4.5, bins = 5 5 5 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair hippo, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d + bin: standard + HIPPO group count: 216 +Per MPI rank memory allocation (min/avg/max) = 55.94 | 55.94 | 55.94 Mbytes + Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] + 0 0 -2188.594 166.82637 77.478353 0 0 244.30473 -1944.2893 -10859.589 -9285.4645 -11598.049 -11695.254 -282.7072 3164.4148 2495.2578 + 10 100.94691 -2350.192 116.13156 88.56605 0 0 204.69761 -1950.8098 -11480.919 -13574.139 -12190.797 -12798.212 -263.77028 280.62864 1974.1486 + 20 153.91622 -2358.3058 36.396961 66.22466 0 0 102.62162 -1958.8438 -7778.4529 -8492.3868 -11999.431 -9125.9998 -917.99962 589.09064 1788.2094 + 30 145.5951 -2343.9956 39.651541 65.833248 0 0 105.48479 -1957.7184 -288.79965 -2574.4466 -3820.4824 -414.28285 -347.51491 -1147.3995 -126.71025 + 40 126.87801 -2340.2623 102.93951 43.896946 0 0 146.83646 -1948.7309 6766.15 5908.7048 1280.0961 7930.8191 -1085.6811 -1596.6859 -714.82888 + 50 134.52078 -2358.9232 107.49288 44.253826 0 0 151.74671 -1947.7419 8762.4348 6023.4661 5377.0189 9396.0316 -1629.1364 -1663.1666 -2381.51 + 60 173.10181 -2374.3854 51.097314 33.03646 0 0 84.133774 -1956.4102 4614.2907 1719.1989 505.79149 4552.3167 -1661.1714 -587.92108 -1380.6732 + 70 184.86849 -2391.6106 39.916931 35.978152 0 0 75.895083 -1959.1811 -2146.9339 -4993.4021 -4095.6729 -4897.5768 -833.09046 1542.411 -1539.5266 + 80 164.75795 -2406.3017 101.94229 33.067832 0 0 135.01013 -1953.542 -8779.3265 -10545.409 -10418.702 -12098.858 -1319.194 1750.3511 -275.1272 + 90 151.17491 -2434.6876 152.21826 41.301673 0 0 193.51993 -1949.6141 -13330.691 -15436.505 -13791.461 -16934.674 149.25497 2289.1026 976.14333 + 100 166.99163 -2452.5298 143.57768 35.341459 0 0 178.91914 -1951.5533 -14918.51 -16077.49 -17353.738 -18140.466 19.009088 1487.0469 1084.0231 +Loop time of 3.60321 on 4 procs for 100 steps with 648 atoms + +Performance: 2.398 ns/day, 10.009 hours/ns, 27.753 timesteps/s +100.0% CPU use with 4 MPI tasks x no OpenMP threads + +HIPPO timing breakdown: + Init time: 0.0162772 0.45% + Repulse time: 0.329178 9.19% + Disp time: 0.244602 6.83% + Mpole time: 0.640969 17.89% + Induce time: 1.44984 40.47% + Polar time: 0.821061 22.92% + Qxfer time: 0.0804381 2.25% + Total time: 3.58237 + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 3.5752 | 3.5827 | 3.59 | 0.4 | 99.43 +Bond | 0.00065212 | 0.00072305 | 0.00075673 | 0.0 | 0.02 +Neigh | 0.0015663 | 0.0015681 | 0.00157 | 0.0 | 0.04 +Comm | 0.0097453 | 0.017024 | 0.024558 | 5.5 | 0.47 +Output | 0.00030331 | 0.0003444 | 0.00045896 | 0.0 | 0.01 +Modify | 0.00018335 | 0.00020346 | 0.00021611 | 0.0 | 0.01 +Other | | 0.0006822 | | | 0.02 + +Nlocal: 162 ave 166 max 160 min +Histogram: 2 0 0 1 0 0 0 0 0 1 +Nghost: 2563.25 ave 2589 max 2535 min +Histogram: 1 1 0 0 0 0 0 0 0 2 +Neighs: 24622.5 ave 25210 max 24056 min +Histogram: 1 0 1 0 0 0 0 1 0 1 + +Total # of neighbors = 98490 +Ave neighs/atom = 151.99074 +Ave special neighs/atom = 2 +Neighbor list builds = 2 +Dangerous builds = 0 +Total wall time: 0:00:03 diff --git a/examples/amoeba/log.7Jul22.water_dimer.amoeba.g++.1 b/examples/amoeba/log.7Jul22.water_dimer.amoeba.g++.1 new file mode 100644 index 0000000000..824e1df844 --- /dev/null +++ b/examples/amoeba/log.7Jul22.water_dimer.amoeba.g++.1 @@ -0,0 +1,147 @@ +LAMMPS (23 Jun 2022) +# water dimer with AMOEBA or HIPPO + +units real +boundary s s s + +atom_style amoeba +bond_style class2 +angle_style amoeba +dihedral_style none + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 + +# read data file + +read_data data.water_dimer.amoeba fix amtype NULL "Tinker Types" +Reading data file ... + orthogonal box = (-1.463996 -0.756549 -0.009705) to (0.933234 0.75612 2.935934) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 6 atoms + scanning bonds ... + 2 = max bonds/atom + scanning angles ... + 1 = max angles/atom + reading bonds ... + 4 bonds + reading angles ... + 2 angles +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + read_data CPU = 0.007 seconds + +# force field + +pair_style amoeba +pair_coeff * * amoeba_water.prm amoeba_water.key +Reading potential file amoeba_water.prm with DATE: 2022-07-05 +Reading potential file amoeba_water.key with DATE: 2022-07-05 + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0.5 0.5 0.5 + special bond factors coul: 0.5 0.5 0.5 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of 1-5 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] + +#dump 1 all custom 10 dump.water_dimer id type x y z fx fy fz +#dump_modify 1 sort id + +# dynamics + +fix 1 all nve + +thermo 10 +run 100 +AMOEBA force field settings + hal: cut 10 taper 8 vscale 0 0 1 1 + multipole: cut 10 aewald 0 mscale 0 0 0.4 1 + polar: cut 10 aewald 0 + pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 1 1 1 1 d/u scale 0 1 + precondition: cut 4.5 +Generated 0 of 1 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 12 + ghost atom cutoff = 12 + binsize = 6, bins = 1 1 1 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair amoeba, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d + bin: standard +WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (../domain.cpp:970) + AMOEBA group count: 2 +Per MPI rank memory allocation (min/avg/max) = 48.33 | 48.33 | 48.33 Mbytes + Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] + 0 0 -5.1627563 0.025695395 0.71581114 0 0 0.74150653 -4.4212497 -12260.522 -43226.042 39448.214 -33003.739 -85.160886 -28101.905 -72.971988 + 10 1.1174766 -4.7928792 0.045080327 0.30848527 0 0 0.35356559 -4.4226587 -14728.416 11456.119 -52592.829 -3262.8454 70.868937 29494.268 57.977562 + 20 3.0821934 -5.1387316 0.013108182 0.65694692 0 0 0.6700551 -4.4227393 3007.4148 -25925.326 49641.41 -15284.933 -79.726771 -29005.234 -68.530079 + 30 3.461967 -4.8079248 0.013888863 0.31895667 0 0 0.33284554 -4.423482 8616.211 40027.877 -31134.295 16291.126 72.510013 23088.238 51.407946 + 40 4.2181367 -5.0535921 0.0099009766 0.55796811 0 0 0.56786908 -4.4228557 24239.885 -5761.6967 62095.735 15576.675 -76.240192 -33057.385 -58.850871 + 50 5.216657 -4.8012751 0.0053003148 0.29489399 0 0 0.30019431 -4.4233315 17728.056 44785.731 -21215.714 28613.715 66.24671 20292.137 51.010856 + 60 9.45101 -5.0818046 0.0043357361 0.5118733 0 0 0.51620903 -4.4247372 16893.135 -15068.961 50111.11 13824.77 -75.966047 -34809.168 -52.83183 + 70 10.385926 -4.8250769 0.022572262 0.22235766 0 0 0.24492992 -4.4253547 -1117.3665 19070.918 -36063.612 11648.813 61.067533 25754.59 53.919881 + 80 12.797691 -5.123735 0.023756795 0.48275385 0 0 0.50651065 -4.4264869 -6491.9826 -28436.037 20681.908 -14176.121 -64.024669 -35737.052 -52.583533 + 90 12.569481 -4.8303379 0.060369422 0.15670502 0 0 0.21707444 -4.4259273 -16762.536 1720.5855 -47624.986 -6793.7441 59.966729 30024.566 52.339671 + 100 17.750788 -5.1195235 0.039885925 0.38711474 0 0 0.42700067 -4.4279642 -10817.92 -21833.456 4186.8301 -18211.329 -43.11086 -32664.671 -41.508916 +Loop time of 0.00539351 on 1 procs for 100 steps with 6 atoms + +Performance: 1601.925 ns/day, 0.015 hours/ns, 18540.802 timesteps/s +97.1% CPU use with 1 MPI tasks x no OpenMP threads + +AMOEBA timing breakdown: + Init time: 0.000111932 2.32% + Hal time: 0.00045057 9.33% + Mpole time: 0.00055958 11.59% + Induce time: 0.00238881 49.46% + Polar time: 0.0013042 27.00% + Total time: 0.00482974 + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.0048575 | 0.0048575 | 0.0048575 | 0.0 | 90.06 +Bond | 9.4036e-05 | 9.4036e-05 | 9.4036e-05 | 0.0 | 1.74 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 1.3435e-05 | 1.3435e-05 | 1.3435e-05 | 0.0 | 0.25 +Output | 0.00034323 | 0.00034323 | 0.00034323 | 0.0 | 6.36 +Modify | 3.5435e-05 | 3.5435e-05 | 3.5435e-05 | 0.0 | 0.66 +Other | | 4.986e-05 | | | 0.92 + +Nlocal: 6 ave 6 max 6 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 0 ave 0 max 0 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 15 ave 15 max 15 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 15 +Ave neighs/atom = 2.5 +Ave special neighs/atom = 2 +Neighbor list builds = 0 +Dangerous builds = 0 +Total wall time: 0:00:00 diff --git a/examples/amoeba/log.7Jul22.water_dimer.amoeba.g++.4 b/examples/amoeba/log.7Jul22.water_dimer.amoeba.g++.4 new file mode 100644 index 0000000000..f4ec45928d --- /dev/null +++ b/examples/amoeba/log.7Jul22.water_dimer.amoeba.g++.4 @@ -0,0 +1,147 @@ +LAMMPS (23 Jun 2022) +# water dimer with AMOEBA or HIPPO + +units real +boundary s s s + +atom_style amoeba +bond_style class2 +angle_style amoeba +dihedral_style none + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 + +# read data file + +read_data data.water_dimer.amoeba fix amtype NULL "Tinker Types" +Reading data file ... + orthogonal box = (-1.463996 -0.756549 -0.009705) to (0.933234 0.75612 2.935934) + 2 by 1 by 2 MPI processor grid + reading atoms ... + 6 atoms + scanning bonds ... + 2 = max bonds/atom + scanning angles ... + 1 = max angles/atom + reading bonds ... + 4 bonds + reading angles ... + 2 angles +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + read_data CPU = 0.009 seconds + +# force field + +pair_style amoeba +pair_coeff * * amoeba_water.prm amoeba_water.key +Reading potential file amoeba_water.prm with DATE: 2022-07-05 +Reading potential file amoeba_water.key with DATE: 2022-07-05 + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0.5 0.5 0.5 + special bond factors coul: 0.5 0.5 0.5 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of 1-5 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] + +#dump 1 all custom 10 dump.water_dimer id type x y z fx fy fz +#dump_modify 1 sort id + +# dynamics + +fix 1 all nve + +thermo 10 +run 100 +AMOEBA force field settings + hal: cut 10 taper 8 vscale 0 0 1 1 + multipole: cut 10 aewald 0 mscale 0 0 0.4 1 + polar: cut 10 aewald 0 + pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 1 1 1 1 d/u scale 0 1 + precondition: cut 4.5 +Generated 0 of 1 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 12 + ghost atom cutoff = 12 + binsize = 6, bins = 1 1 1 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair amoeba, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d + bin: standard +WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (../domain.cpp:970) + AMOEBA group count: 2 +Per MPI rank memory allocation (min/avg/max) = 48.35 | 48.48 | 48.62 Mbytes + Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] + 0 0 -5.1627563 0.025695395 0.71581114 0 0 0.74150653 -4.4212497 -12260.522 -43226.042 39448.214 -33003.739 -85.160886 -28101.905 -72.971988 + 10 1.1174766 -4.7928792 0.045080327 0.30848527 0 0 0.35356559 -4.4226587 -14728.416 11456.119 -52592.829 -3262.8454 70.868937 29494.268 57.977562 + 20 3.0821934 -5.1387316 0.013108182 0.65694692 0 0 0.6700551 -4.4227393 3007.4148 -25925.326 49641.41 -15284.933 -79.726771 -29005.234 -68.530079 + 30 3.461967 -4.8079248 0.013888863 0.31895667 0 0 0.33284554 -4.423482 8616.211 40027.877 -31134.295 16291.126 72.510013 23088.238 51.407946 + 40 4.2181367 -5.0535921 0.0099009766 0.55796811 0 0 0.56786908 -4.4228557 24239.885 -5761.6967 62095.735 15576.675 -76.240192 -33057.385 -58.850871 + 50 5.216657 -4.8012751 0.0053003148 0.29489399 0 0 0.30019431 -4.4233315 17728.056 44785.731 -21215.714 28613.715 66.24671 20292.137 51.010856 + 60 9.45101 -5.0818046 0.0043357361 0.5118733 0 0 0.51620903 -4.4247372 16893.135 -15068.961 50111.11 13824.77 -75.966047 -34809.168 -52.83183 + 70 10.385926 -4.8250769 0.022572262 0.22235766 0 0 0.24492992 -4.4253547 -1117.3665 19070.918 -36063.612 11648.813 61.067533 25754.59 53.919881 + 80 12.797691 -5.123735 0.023756795 0.48275385 0 0 0.50651065 -4.4264869 -6491.9826 -28436.037 20681.908 -14176.121 -64.024669 -35737.052 -52.583533 + 90 12.569481 -4.8303379 0.060369422 0.15670502 0 0 0.21707444 -4.4259273 -16762.536 1720.5855 -47624.986 -6793.7441 59.966729 30024.566 52.339671 + 100 17.750788 -5.1195235 0.039885925 0.38711474 0 0 0.42700067 -4.4279642 -10817.92 -21833.456 4186.8301 -18211.329 -43.11086 -32664.671 -41.508916 +Loop time of 0.0160927 on 4 procs for 100 steps with 6 atoms + +Performance: 536.891 ns/day, 0.045 hours/ns, 6214.012 timesteps/s +99.7% CPU use with 4 MPI tasks x no OpenMP threads + +AMOEBA timing breakdown: + Init time: 0.000643833 4.58% + Hal time: 0.000105979 0.75% + Mpole time: 0.00070704 5.03% + Induce time: 0.0115637 82.32% + Polar time: 0.00101148 7.20% + Total time: 0.0140469 + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.014163 | 0.014289 | 0.01443 | 0.1 | 88.79 +Bond | 1.3072e-05 | 4.8341e-05 | 8.4206e-05 | 0.0 | 0.30 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.00071242 | 0.00081499 | 0.0010064 | 0.0 | 5.06 +Output | 0.00041395 | 0.00049646 | 0.0005516 | 0.0 | 3.08 +Modify | 2.5768e-05 | 3.3385e-05 | 4.7843e-05 | 0.0 | 0.21 +Other | | 0.0004106 | | | 2.55 + +Nlocal: 1.5 ave 3 max 0 min +Histogram: 2 0 0 0 0 0 0 0 0 2 +Nghost: 4.5 ave 6 max 3 min +Histogram: 2 0 0 0 0 0 0 0 0 2 +Neighs: 3.75 ave 12 max 0 min +Histogram: 2 0 1 0 0 0 0 0 0 1 + +Total # of neighbors = 15 +Ave neighs/atom = 2.5 +Ave special neighs/atom = 2 +Neighbor list builds = 0 +Dangerous builds = 0 +Total wall time: 0:00:00 diff --git a/examples/amoeba/log.7Jul22.water_dimer.hippo.g++.1 b/examples/amoeba/log.7Jul22.water_dimer.hippo.g++.1 new file mode 100644 index 0000000000..5eaf8cf8a5 --- /dev/null +++ b/examples/amoeba/log.7Jul22.water_dimer.hippo.g++.1 @@ -0,0 +1,151 @@ +LAMMPS (23 Jun 2022) +# water dimer with AMOEBA or HIPPO + +units real +boundary s s s + +atom_style amoeba +bond_style class2 +angle_style amoeba +dihedral_style none + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 + +# read data file + +read_data data.water_dimer.hippo fix amtype NULL "Tinker Types" +Reading data file ... + orthogonal box = (-1.463996 -0.756549 -0.009705) to (0.933234 0.75612 2.935934) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 6 atoms + scanning bonds ... + 2 = max bonds/atom + scanning angles ... + 1 = max angles/atom + reading bonds ... + 4 bonds + reading angles ... + 2 angles +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + read_data CPU = 0.007 seconds + +# force field + +pair_style hippo +pair_coeff * * hippo_water.prm hippo_water.key +Reading potential file hippo_water.prm with DATE: 2022-07-05 +Reading potential file hippo_water.key with DATE: 2022-07-05 + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0.5 0.5 0.5 + special bond factors coul: 0.5 0.5 0.5 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of 1-5 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] + +#dump 1 all custom 10 dump.water_dimer id type x y z fx fy fz +#dump_modify 1 sort id + +# dynamics + +fix 1 all nve + +thermo 10 +run 100 +HIPPO force field settings + repulsion: cut 10 taper 8 rscale 0 0 1 1 + qxfer: cut 10 taper 8 mscale 0 0 0.4 1 + dispersion: cut 10 aewald 0 dspscale 0 0 0.4 1 + multipole: cut 10 aewald 0 mscale 0 0 0.4 1 + polar: cut 10 aewald 0 + pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 0.2 1 1 1 d/u scale 0 1 + precondition: cut 4.5 +Generated 0 of 1 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 12 + ghost atom cutoff = 12 + binsize = 6, bins = 1 1 1 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair hippo, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d + bin: standard +WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (../domain.cpp:970) + HIPPO group count: 2 +Per MPI rank memory allocation (min/avg/max) = 47.9 | 47.9 | 47.9 Mbytes + Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] + 0 0 -5.0101954 0.025695395 0.51472748 0 0 0.54042288 -4.4697726 -11875.159 -38149.178 29162.678 -26638.977 -70.63422 -24614.614 -58.505595 + 10 0.75132894 -4.7952077 0.028216017 0.28494196 0 0 0.31315798 -4.4708519 -13243.822 12661.254 -49613.657 -2923.1497 69.449413 29456.684 56.087663 + 20 2.1716525 -5.0036265 0.011809223 0.48875837 0 0 0.50056759 -4.4706925 4371.5298 -22102.532 47044.297 -12243.648 -74.588915 -28903.762 -64.48154 + 30 2.9930198 -4.8261906 0.0091463366 0.30162756 0 0 0.3107739 -4.4708086 9992.4549 41973.539 -20985.339 8415.1715 67.458145 25027.414 40.261795 + 40 3.312268 -4.9802484 0.010400667 0.45076258 0 0 0.46116325 -4.4697189 21565.307 -11602.414 65186.215 10476.902 -83.374203 -33222.094 -64.700001 + 50 4.3187397 -4.8535614 0.0060313545 0.31244652 0 0 0.31847788 -4.4707168 11344.244 45839.35 -21073.749 8438.8954 73.345039 29422.636 43.897876 + 60 4.9127902 -5.0035271 0.0070589202 0.45246538 0 0 0.4595243 -4.4707824 6529.9354 -37107.891 46740.24 9015.2973 -90.41111 -34402.095 -53.57079 + 70 5.3145827 -4.8748857 0.025797484 0.29875503 0 0 0.32455252 -4.4711244 -10208.876 26324.134 -49272.688 -8697.2875 84.479942 36185.667 57.000355 + 80 3.8409793 -5.0262066 0.027669388 0.47104466 0 0 0.49871405 -4.4702464 -9777.1809 -52088.554 28053.855 -6033.4555 -94.607853 -44638.417 -59.108505 + 90 3.0683704 -4.8369716 0.035455716 0.28466932 0 0 0.32012503 -4.4711155 -10626.245 31066.635 -49425.925 -14107.889 87.765958 34632.905 52.101981 + 100 3.5262799 -4.9906817 0.016687539 0.45011301 0 0 0.46680055 -4.4713252 5216.7691 -34991.221 43883.163 6082.1058 -95.830393 -48645.129 -64.784334 +Loop time of 0.00554871 on 1 procs for 100 steps with 6 atoms + +Performance: 1557.118 ns/day, 0.015 hours/ns, 18022.197 timesteps/s +98.4% CPU use with 1 MPI tasks x no OpenMP threads + +HIPPO timing breakdown: + Init time: 0.000115545 2.34% + Repulse time: 0.000625219 12.67% + Disp time: 0.000296056 6.00% + Mpole time: 0.000954451 19.35% + Induce time: 0.00169706 34.40% + Polar time: 0.001079 21.87% + Qxfer time: 0.000160858 3.26% + Total time: 0.0049333 + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.0049642 | 0.0049642 | 0.0049642 | 0.0 | 89.47 +Bond | 8.7687e-05 | 8.7687e-05 | 8.7687e-05 | 0.0 | 1.58 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 1.8012e-05 | 1.8012e-05 | 1.8012e-05 | 0.0 | 0.32 +Output | 0.00037567 | 0.00037567 | 0.00037567 | 0.0 | 6.77 +Modify | 4.1717e-05 | 4.1717e-05 | 4.1717e-05 | 0.0 | 0.75 +Other | | 6.144e-05 | | | 1.11 + +Nlocal: 6 ave 6 max 6 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 0 ave 0 max 0 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 15 ave 15 max 15 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 15 +Ave neighs/atom = 2.5 +Ave special neighs/atom = 2 +Neighbor list builds = 0 +Dangerous builds = 0 +Total wall time: 0:00:00 diff --git a/examples/amoeba/log.7Jul22.water_dimer.hippo.g++.4 b/examples/amoeba/log.7Jul22.water_dimer.hippo.g++.4 new file mode 100644 index 0000000000..cccd71a5d6 --- /dev/null +++ b/examples/amoeba/log.7Jul22.water_dimer.hippo.g++.4 @@ -0,0 +1,151 @@ +LAMMPS (23 Jun 2022) +# water dimer with AMOEBA or HIPPO + +units real +boundary s s s + +atom_style amoeba +bond_style class2 +angle_style amoeba +dihedral_style none + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 + +# read data file + +read_data data.water_dimer.hippo fix amtype NULL "Tinker Types" +Reading data file ... + orthogonal box = (-1.463996 -0.756549 -0.009705) to (0.933234 0.75612 2.935934) + 2 by 1 by 2 MPI processor grid + reading atoms ... + 6 atoms + scanning bonds ... + 2 = max bonds/atom + scanning angles ... + 1 = max angles/atom + reading bonds ... + 4 bonds + reading angles ... + 2 angles +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + read_data CPU = 0.008 seconds + +# force field + +pair_style hippo +pair_coeff * * hippo_water.prm hippo_water.key +Reading potential file hippo_water.prm with DATE: 2022-07-05 +Reading potential file hippo_water.key with DATE: 2022-07-05 + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0.5 0.5 0.5 + special bond factors coul: 0.5 0.5 0.5 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of 1-5 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] + +#dump 1 all custom 10 dump.water_dimer id type x y z fx fy fz +#dump_modify 1 sort id + +# dynamics + +fix 1 all nve + +thermo 10 +run 100 +HIPPO force field settings + repulsion: cut 10 taper 8 rscale 0 0 1 1 + qxfer: cut 10 taper 8 mscale 0 0 0.4 1 + dispersion: cut 10 aewald 0 dspscale 0 0 0.4 1 + multipole: cut 10 aewald 0 mscale 0 0 0.4 1 + polar: cut 10 aewald 0 + pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 0.2 1 1 1 d/u scale 0 1 + precondition: cut 4.5 +Generated 0 of 1 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 12 + ghost atom cutoff = 12 + binsize = 6, bins = 1 1 1 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair hippo, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d + bin: standard +WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (../domain.cpp:970) + HIPPO group count: 2 +Per MPI rank memory allocation (min/avg/max) = 47.91 | 48.04 | 48.18 Mbytes + Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] + 0 0 -5.0101954 0.025695395 0.51472748 0 0 0.54042288 -4.4697726 -11875.159 -38149.178 29162.678 -26638.977 -70.63422 -24614.614 -58.505595 + 10 0.75132894 -4.7952077 0.028216017 0.28494196 0 0 0.31315798 -4.4708519 -13243.822 12661.254 -49613.657 -2923.1497 69.449413 29456.684 56.087663 + 20 2.1716525 -5.0036265 0.011809223 0.48875837 0 0 0.50056759 -4.4706925 4371.5298 -22102.532 47044.297 -12243.648 -74.588915 -28903.762 -64.48154 + 30 2.9930198 -4.8261906 0.0091463366 0.30162756 0 0 0.3107739 -4.4708086 9992.4549 41973.539 -20985.339 8415.1715 67.458145 25027.414 40.261795 + 40 3.312268 -4.9802484 0.010400667 0.45076258 0 0 0.46116325 -4.4697189 21565.307 -11602.414 65186.215 10476.902 -83.374203 -33222.094 -64.700001 + 50 4.3187397 -4.8535614 0.0060313545 0.31244652 0 0 0.31847788 -4.4707168 11344.244 45839.35 -21073.749 8438.8954 73.345039 29422.636 43.897876 + 60 4.9127902 -5.0035271 0.0070589202 0.45246538 0 0 0.4595243 -4.4707824 6529.9354 -37107.891 46740.24 9015.2973 -90.41111 -34402.095 -53.57079 + 70 5.3145827 -4.8748857 0.025797484 0.29875503 0 0 0.32455252 -4.4711244 -10208.876 26324.134 -49272.688 -8697.2875 84.479942 36185.667 57.000355 + 80 3.8409793 -5.0262066 0.027669388 0.47104466 0 0 0.49871405 -4.4702464 -9777.1809 -52088.554 28053.855 -6033.4555 -94.607853 -44638.417 -59.108505 + 90 3.0683704 -4.8369716 0.035455716 0.28466932 0 0 0.32012503 -4.4711155 -10626.245 31066.635 -49425.925 -14107.889 87.765958 34632.905 52.101981 + 100 3.5262799 -4.9906817 0.016687539 0.45011301 0 0 0.46680055 -4.4713252 5216.7691 -34991.221 43883.163 6082.1058 -95.830393 -48645.129 -64.784334 +Loop time of 0.0121417 on 4 procs for 100 steps with 6 atoms + +Performance: 711.596 ns/day, 0.034 hours/ns, 8236.062 timesteps/s +99.4% CPU use with 4 MPI tasks x no OpenMP threads + +HIPPO timing breakdown: + Init time: 0.000597179 5.89% + Repulse time: 0.000498881 4.92% + Disp time: 8.8931e-05 0.88% + Mpole time: 0.000837487 8.26% + Induce time: 0.00727381 71.77% + Polar time: 0.000785393 7.75% + Qxfer time: 4.87313e-05 0.48% + Total time: 0.0101354 + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.010257 | 0.010374 | 0.01049 | 0.1 | 85.44 +Bond | 1.2833e-05 | 4.7018e-05 | 8.6931e-05 | 0.0 | 0.39 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.0006916 | 0.00076578 | 0.00092404 | 0.0 | 6.31 +Output | 0.00040685 | 0.00049547 | 0.00057258 | 0.0 | 4.08 +Modify | 3.3096e-05 | 3.6004e-05 | 4.4046e-05 | 0.0 | 0.30 +Other | | 0.0004238 | | | 3.49 + +Nlocal: 1.5 ave 3 max 0 min +Histogram: 2 0 0 0 0 0 0 0 0 2 +Nghost: 4.5 ave 6 max 3 min +Histogram: 2 0 0 0 0 0 0 0 0 2 +Neighs: 3.75 ave 12 max 0 min +Histogram: 2 0 1 0 0 0 0 0 0 1 + +Total # of neighbors = 15 +Ave neighs/atom = 2.5 +Ave special neighs/atom = 2 +Neighbor list builds = 0 +Dangerous builds = 0 +Total wall time: 0:00:00 diff --git a/examples/amoeba/log.7Jul22.water_hexamer.amoeba.g++.1 b/examples/amoeba/log.7Jul22.water_hexamer.amoeba.g++.1 new file mode 100644 index 0000000000..ba9d7c5391 --- /dev/null +++ b/examples/amoeba/log.7Jul22.water_hexamer.amoeba.g++.1 @@ -0,0 +1,146 @@ +LAMMPS (23 Jun 2022) +# water hexamer with AMOEBA or HIPPO + +units real +boundary s s s + +atom_style amoeba +bond_style class2 +angle_style amoeba +dihedral_style none + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 + +# read data file + +read_data data.water_hexamer.amoeba fix amtype NULL "Tinker Types" +Reading data file ... + orthogonal box = (-2.517835 -1.523041 -1.734766) to (2.675716 2.01883 2.220847) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 18 atoms + scanning bonds ... + 2 = max bonds/atom + scanning angles ... + 1 = max angles/atom + reading bonds ... + 12 bonds + reading angles ... + 6 angles +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + read_data CPU = 0.007 seconds + +# force field + +pair_style amoeba +pair_coeff * * amoeba_water.prm amoeba_water.key +Reading potential file amoeba_water.prm with DATE: 2022-07-05 +Reading potential file amoeba_water.key with DATE: 2022-07-05 + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0.5 0.5 0.5 + special bond factors coul: 0.5 0.5 0.5 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of 1-5 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] + +#dump 1 all custom 10 dump.water_hexamer id type x y z fx fy fz +#dump_modify 1 sort id + +# dynamics + +fix 1 all nve + +thermo 10 +run 100 +AMOEBA force field settings + hal: cut 10 taper 8 vscale 0 0 1 1 + multipole: cut 10 aewald 0 mscale 0 0 0.4 1 + polar: cut 10 aewald 0 + pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 1 1 1 1 d/u scale 0 1 + precondition: cut 4.5 +Generated 0 of 1 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 12 + ghost atom cutoff = 12 + binsize = 6, bins = 1 1 1 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair amoeba, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d + bin: standard + AMOEBA group count: 6 +Per MPI rank memory allocation (min/avg/max) = 48.28 | 48.28 | 48.28 Mbytes + Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] + 0 0 -48.469664 1.9820353 2.2499329 0 0 4.2319683 -44.237696 -26322.671 -28303.103 -27669.614 -22995.296 1312.6688 2624.8394 4042.0489 + 10 6.3616471 -46.626437 1.7910812 0.25704063 0 0 2.0481218 -44.255947 -23813.06 -24671.886 -17167.34 -30208.043 -474.208 -8339.5934 -5278.359 + 20 15.149798 -48.177533 1.1130818 2.007499 0 0 3.1205807 -44.289255 -16468.855 -20150.975 -18596.629 -12107.083 885.52697 6320.1867 3064.949 + 30 17.896968 -45.959274 0.54802739 0.19519937 0 0 0.74322676 -44.309141 -4749.0624 -9053.7792 -182.37209 -6721.7499 -2003.7641 -627.56998 -1658.1301 + 40 16.203813 -46.840973 0.1371751 1.5793326 0 0 1.7165077 -44.303357 9267.4858 6108.7966 4116.4548 16028.336 380.03787 8468.0648 4492.3331 + 50 11.584975 -45.166711 0.017120512 0.28622888 0 0 0.30334939 -44.276308 22189.511 21453.083 22339.471 21668.607 150.93139 1059.5253 200.0668 + 60 10.002055 -45.994946 0.037889337 1.1987062 0 0 1.2365956 -44.251509 30944.004 35801.925 19832.696 36241.326 2042.3054 2320.5193 1660.0834 + 70 11.272241 -45.411622 0.07431614 0.51778317 0 0 0.59209931 -44.248316 32055.564 39306.193 30181.52 25601.501 1373.4778 -4501.0686 -2570.4767 + 80 14.011502 -46.081444 0.089688317 1.006928 0 0 1.0966163 -44.274812 25661.838 38836.598 12603.734 24205.867 -867.36437 -4211.9639 -2820.6725 + 90 17.659498 -46.247295 0.21744649 0.82687716 0 0 1.0443237 -44.308098 12101.207 19426.995 14142.311 1046.299 -2157.5418 -2141.2454 -2621.456 + 100 17.630532 -46.788272 0.61811601 0.9654966 0 0 1.5836126 -44.311254 -4455.3587 3961.5737 -11554.095 -7458.8012 -3120.9771 -1532.1706 -1499.0117 +Loop time of 0.0418011 on 1 procs for 100 steps with 18 atoms + +Performance: 206.693 ns/day, 0.116 hours/ns, 2392.284 timesteps/s +99.4% CPU use with 1 MPI tasks x no OpenMP threads + +AMOEBA timing breakdown: + Init time: 0.000326312 0.80% + Hal time: 0.0050371 12.28% + Mpole time: 0.00454501 11.08% + Induce time: 0.0200157 48.79% + Polar time: 0.0110863 27.02% + Total time: 0.0410272 + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.041065 | 0.041065 | 0.041065 | 0.0 | 98.24 +Bond | 0.00019979 | 0.00019979 | 0.00019979 | 0.0 | 0.48 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 1.5617e-05 | 1.5617e-05 | 1.5617e-05 | 0.0 | 0.04 +Output | 0.00037937 | 0.00037937 | 0.00037937 | 0.0 | 0.91 +Modify | 6.5901e-05 | 6.5901e-05 | 6.5901e-05 | 0.0 | 0.16 +Other | | 7.527e-05 | | | 0.18 + +Nlocal: 18 ave 18 max 18 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 0 ave 0 max 0 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 153 ave 153 max 153 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 153 +Ave neighs/atom = 8.5 +Ave special neighs/atom = 2 +Neighbor list builds = 0 +Dangerous builds = 0 +Total wall time: 0:00:00 diff --git a/examples/amoeba/log.7Jul22.water_hexamer.amoeba.g++.4 b/examples/amoeba/log.7Jul22.water_hexamer.amoeba.g++.4 new file mode 100644 index 0000000000..1cbc7797e9 --- /dev/null +++ b/examples/amoeba/log.7Jul22.water_hexamer.amoeba.g++.4 @@ -0,0 +1,147 @@ +LAMMPS (23 Jun 2022) +# water hexamer with AMOEBA or HIPPO + +units real +boundary s s s + +atom_style amoeba +bond_style class2 +angle_style amoeba +dihedral_style none + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 + +# read data file + +read_data data.water_hexamer.amoeba fix amtype NULL "Tinker Types" +Reading data file ... + orthogonal box = (-2.517835 -1.523041 -1.734766) to (2.675716 2.01883 2.220847) + 2 by 1 by 2 MPI processor grid + reading atoms ... + 18 atoms + scanning bonds ... + 2 = max bonds/atom + scanning angles ... + 1 = max angles/atom + reading bonds ... + 12 bonds + reading angles ... + 6 angles +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + read_data CPU = 0.008 seconds + +# force field + +pair_style amoeba +pair_coeff * * amoeba_water.prm amoeba_water.key +Reading potential file amoeba_water.prm with DATE: 2022-07-05 +Reading potential file amoeba_water.key with DATE: 2022-07-05 + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0.5 0.5 0.5 + special bond factors coul: 0.5 0.5 0.5 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of 1-5 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] + +#dump 1 all custom 10 dump.water_hexamer id type x y z fx fy fz +#dump_modify 1 sort id + +# dynamics + +fix 1 all nve + +thermo 10 +run 100 +AMOEBA force field settings + hal: cut 10 taper 8 vscale 0 0 1 1 + multipole: cut 10 aewald 0 mscale 0 0 0.4 1 + polar: cut 10 aewald 0 + pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 1 1 1 1 d/u scale 0 1 + precondition: cut 4.5 +Generated 0 of 1 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 12 + ghost atom cutoff = 12 + binsize = 6, bins = 1 1 1 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair amoeba, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d + bin: standard +WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (../domain.cpp:970) + AMOEBA group count: 6 +Per MPI rank memory allocation (min/avg/max) = 48.3 | 48.3 | 48.3 Mbytes + Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] + 0 0 -48.469664 1.9820353 2.2499329 0 0 4.2319683 -44.237696 -26322.671 -28303.103 -27669.614 -22995.296 1312.6688 2624.8394 4042.0489 + 10 6.3616471 -46.626437 1.7910812 0.25704063 0 0 2.0481218 -44.255947 -23813.06 -24671.886 -17167.34 -30208.043 -474.208 -8339.5934 -5278.359 + 20 15.149798 -48.177533 1.1130818 2.007499 0 0 3.1205807 -44.289255 -16468.855 -20150.975 -18596.629 -12107.083 885.52697 6320.1867 3064.949 + 30 17.896968 -45.959274 0.54802739 0.19519937 0 0 0.74322676 -44.309141 -4749.0624 -9053.7792 -182.37209 -6721.7499 -2003.7641 -627.56998 -1658.1301 + 40 16.203813 -46.840973 0.1371751 1.5793326 0 0 1.7165077 -44.303357 9267.4858 6108.7966 4116.4548 16028.336 380.03787 8468.0648 4492.3331 + 50 11.584975 -45.166711 0.017120512 0.28622888 0 0 0.30334939 -44.276308 22189.511 21453.083 22339.471 21668.607 150.93139 1059.5253 200.0668 + 60 10.002055 -45.994946 0.037889337 1.1987062 0 0 1.2365956 -44.251509 30944.004 35801.925 19832.696 36241.326 2042.3054 2320.5193 1660.0834 + 70 11.272241 -45.411622 0.07431614 0.51778317 0 0 0.59209931 -44.248316 32055.564 39306.193 30181.52 25601.501 1373.4778 -4501.0686 -2570.4767 + 80 14.011502 -46.081444 0.089688317 1.006928 0 0 1.0966163 -44.274812 25661.838 38836.598 12603.734 24205.867 -867.36437 -4211.9639 -2820.6725 + 90 17.659498 -46.247295 0.21744649 0.82687716 0 0 1.0443237 -44.308098 12101.207 19426.995 14142.311 1046.299 -2157.5418 -2141.2454 -2621.456 + 100 17.630532 -46.788272 0.61811601 0.9654966 0 0 1.5836126 -44.311254 -4455.3587 3961.5737 -11554.095 -7458.8012 -3120.9771 -1532.1706 -1499.0117 +Loop time of 0.0397428 on 4 procs for 100 steps with 18 atoms + +Performance: 217.398 ns/day, 0.110 hours/ns, 2516.180 timesteps/s +100.0% CPU use with 4 MPI tasks x no OpenMP threads + +AMOEBA timing breakdown: + Init time: 0.000772875 2.05% + Hal time: 0.00114925 3.04% + Mpole time: 0.00316129 8.37% + Induce time: 0.0278156 73.61% + Polar time: 0.0048762 12.90% + Total time: 0.0377876 + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.03793 | 0.038002 | 0.038115 | 0.0 | 95.62 +Bond | 6.3821e-05 | 8.0969e-05 | 9.9652e-05 | 0.0 | 0.20 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.00067584 | 0.00085989 | 0.0009896 | 0.0 | 2.16 +Output | 0.00035407 | 0.00040202 | 0.00051789 | 0.0 | 1.01 +Modify | 3.6589e-05 | 4.0916e-05 | 4.417e-05 | 0.0 | 0.10 +Other | | 0.0003569 | | | 0.90 + +Nlocal: 4.5 ave 6 max 3 min +Histogram: 1 0 0 1 0 0 1 0 0 1 +Nghost: 13.5 ave 15 max 12 min +Histogram: 1 0 0 1 0 0 1 0 0 1 +Neighs: 38.25 ave 77 max 9 min +Histogram: 2 0 0 0 0 0 1 0 0 1 + +Total # of neighbors = 153 +Ave neighs/atom = 8.5 +Ave special neighs/atom = 2 +Neighbor list builds = 0 +Dangerous builds = 0 +Total wall time: 0:00:00 diff --git a/examples/amoeba/log.7Jul22.water_hexamer.hippo.g++.1 b/examples/amoeba/log.7Jul22.water_hexamer.hippo.g++.1 new file mode 100644 index 0000000000..b94be8930b --- /dev/null +++ b/examples/amoeba/log.7Jul22.water_hexamer.hippo.g++.1 @@ -0,0 +1,150 @@ +LAMMPS (23 Jun 2022) +# water hexamer with AMOEBA or HIPPO + +units real +boundary s s s + +atom_style amoeba +bond_style class2 +angle_style amoeba +dihedral_style none + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 + +# read data file + +read_data data.water_hexamer.hippo fix amtype NULL "Tinker Types" +Reading data file ... + orthogonal box = (-2.517835 -1.523041 -1.734766) to (2.675716 2.01883 2.220847) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 18 atoms + scanning bonds ... + 2 = max bonds/atom + scanning angles ... + 1 = max angles/atom + reading bonds ... + 12 bonds + reading angles ... + 6 angles +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + read_data CPU = 0.007 seconds + +# force field + +pair_style hippo +pair_coeff * * hippo_water.prm hippo_water.key +Reading potential file hippo_water.prm with DATE: 2022-07-05 +Reading potential file hippo_water.key with DATE: 2022-07-05 + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0.5 0.5 0.5 + special bond factors coul: 0.5 0.5 0.5 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of 1-5 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] + +#dump 1 all custom 10 dump.water_hexamer id type x y z fx fy fz +#dump_modify 1 sort id + +# dynamics + +fix 1 all nve + +thermo 10 +run 100 +HIPPO force field settings + repulsion: cut 10 taper 8 rscale 0 0 1 1 + qxfer: cut 10 taper 8 mscale 0 0 0.4 1 + dispersion: cut 10 aewald 0 dspscale 0 0 0.4 1 + multipole: cut 10 aewald 0 mscale 0 0 0.4 1 + polar: cut 10 aewald 0 + pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 0.2 1 1 1 d/u scale 0 1 + precondition: cut 4.5 +Generated 0 of 1 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 12 + ghost atom cutoff = 12 + binsize = 6, bins = 1 1 1 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair hippo, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d + bin: standard + HIPPO group count: 6 +Per MPI rank memory allocation (min/avg/max) = 47.84 | 47.84 | 47.84 Mbytes + Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] + 0 0 -47.362156 1.9820353 1.6634749 0 0 3.6455102 -43.716646 -34513.768 -42206.078 -31383.641 -29951.584 2850.1184 3579.9253 5768.3698 + 10 11.52238 -45.959856 1.53397 0.085100522 0 0 1.6190706 -43.756903 -28644.676 -34867.94 -19324.955 -32842.522 -370.63233 -6452.0859 -4002.3535 + 20 20.237283 -46.772008 0.54762833 1.3835192 0 0 1.9311476 -43.815361 -10546.356 -10116.359 -17063.425 -6393.701 -1166.7608 4243.6327 3493.9596 + 30 20.666374 -45.011106 0.086797459 0.071122604 0 0 0.15792006 -43.805943 13150.762 15882.022 10964.553 10630.278 -6754.7642 -432.29165 -3783.115 + 40 10.639014 -45.430939 0.18926921 0.96410995 0 0 1.1533792 -43.738441 33402.664 41252.58 19726.586 38211.875 -6166.03 6081.5692 1815.7739 + 50 10.992432 -44.741108 0.19575431 0.25851128 0 0 0.45426559 -43.729815 37696.923 41572.466 33299.43 37168.141 -3254.5134 2.9639226 -1017.3669 + 60 19.748633 -45.461264 0.035287281 0.63217389 0 0 0.66746117 -43.793065 26212.839 28825.788 16048.096 31876.925 3504.5461 135.3505 420.28566 + 70 26.129957 -46.022729 0.30434543 0.56770169 0 0 0.87204711 -43.826579 3919.9866 -2755.6905 11500.428 517.54333 5626.9543 -2238.5786 86.305984 + 80 17.768494 -46.309777 1.1680612 0.45551823 0 0 1.6235794 -43.785801 -18335.898 -22168.789 -14488.992 -20048.346 7343.173 -2646.2196 -2525.6625 + 90 8.3822494 -47.063502 2.0182644 0.88875358 0 0 2.9070179 -43.731724 -33693.203 -43487.996 -15178.35 -43214.494 2412.6411 1993.0113 1780.7512 + 100 8.6486333 -46.517402 1.9551958 0.38696887 0 0 2.3421647 -43.736979 -34734.97 -34372.659 -28372.146 -42286.799 226.18821 40.353457 -755.93912 +Loop time of 0.0384281 on 1 procs for 100 steps with 18 atoms + +Performance: 224.836 ns/day, 0.107 hours/ns, 2602.266 timesteps/s +99.7% CPU use with 1 MPI tasks x no OpenMP threads + +HIPPO timing breakdown: + Init time: 0.000296169 0.79% + Repulse time: 0.00605807 16.08% + Disp time: 0.00222186 5.90% + Mpole time: 0.00734879 19.51% + Induce time: 0.0128126 34.02% + Polar time: 0.00749189 19.89% + Qxfer time: 0.00142542 3.78% + Total time: 0.0376635 + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.037703 | 0.037703 | 0.037703 | 0.0 | 98.11 +Bond | 0.00016755 | 0.00016755 | 0.00016755 | 0.0 | 0.44 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 2.4711e-05 | 2.4711e-05 | 2.4711e-05 | 0.0 | 0.06 +Output | 0.00038288 | 0.00038288 | 0.00038288 | 0.0 | 1.00 +Modify | 6.4863e-05 | 6.4863e-05 | 6.4863e-05 | 0.0 | 0.17 +Other | | 8.521e-05 | | | 0.22 + +Nlocal: 18 ave 18 max 18 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 0 ave 0 max 0 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 153 ave 153 max 153 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 153 +Ave neighs/atom = 8.5 +Ave special neighs/atom = 2 +Neighbor list builds = 0 +Dangerous builds = 0 +Total wall time: 0:00:00 diff --git a/examples/amoeba/log.7Jul22.water_hexamer.hippo.g++.4 b/examples/amoeba/log.7Jul22.water_hexamer.hippo.g++.4 new file mode 100644 index 0000000000..aeb3bd7420 --- /dev/null +++ b/examples/amoeba/log.7Jul22.water_hexamer.hippo.g++.4 @@ -0,0 +1,151 @@ +LAMMPS (23 Jun 2022) +# water hexamer with AMOEBA or HIPPO + +units real +boundary s s s + +atom_style amoeba +bond_style class2 +angle_style amoeba +dihedral_style none + +# per-atom properties required by AMOEBA or HIPPO + +fix amtype all property/atom i_amtype ghost yes +fix extra all property/atom i_amgroup d_redID d_pval ghost yes +fix extra2 all property/atom i_polaxe d2_xyzaxis 3 + +# read data file + +read_data data.water_hexamer.hippo fix amtype NULL "Tinker Types" +Reading data file ... + orthogonal box = (-2.517835 -1.523041 -1.734766) to (2.675716 2.01883 2.220847) + 2 by 1 by 2 MPI processor grid + reading atoms ... + 18 atoms + scanning bonds ... + 2 = max bonds/atom + scanning angles ... + 1 = max angles/atom + reading bonds ... + 12 bonds + reading angles ... + 6 angles +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.000 seconds + read_data CPU = 0.008 seconds + +# force field + +pair_style hippo +pair_coeff * * hippo_water.prm hippo_water.key +Reading potential file hippo_water.prm with DATE: 2022-07-05 +Reading potential file hippo_water.key with DATE: 2022-07-05 + +special_bonds lj/coul 0.5 0.5 0.5 one/five yes +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0.5 0.5 0.5 + special bond factors coul: 0.5 0.5 0.5 + 2 = max # of 1-2 neighbors + 1 = max # of 1-3 neighbors + 1 = max # of 1-4 neighbors + 2 = max # of 1-5 neighbors + 2 = max # of special neighbors + special bonds CPU = 0.001 seconds + +# thermo output + +compute virial all pressure NULL virial + +thermo_style custom step temp epair ebond eangle edihed eimp emol etotal press c_virial[*] + +#dump 1 all custom 10 dump.water_hexamer id type x y z fx fy fz +#dump_modify 1 sort id + +# dynamics + +fix 1 all nve + +thermo 10 +run 100 +HIPPO force field settings + repulsion: cut 10 taper 8 rscale 0 0 1 1 + qxfer: cut 10 taper 8 mscale 0 0 0.4 1 + dispersion: cut 10 aewald 0 dspscale 0 0 0.4 1 + multipole: cut 10 aewald 0 mscale 0 0 0.4 1 + polar: cut 10 aewald 0 + pscale 0 0 1 1 piscale 0 0 0.5 1 wscale 0.2 1 1 1 d/u scale 0 1 + precondition: cut 4.5 +Generated 0 of 1 mixed pair_coeff terms from geometric mixing rule +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 12 + ghost atom cutoff = 12 + binsize = 6, bins = 1 1 1 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair hippo, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d + bin: standard +WARNING: Proc sub-domain size < neighbor skin, could lead to lost atoms (../domain.cpp:970) + HIPPO group count: 6 +Per MPI rank memory allocation (min/avg/max) = 47.86 | 47.86 | 47.86 Mbytes + Step Temp E_pair E_bond E_angle E_dihed E_impro E_mol TotEng Press c_virial[1] c_virial[2] c_virial[3] c_virial[4] c_virial[5] c_virial[6] + 0 0 -47.362156 1.9820353 1.6634749 0 0 3.6455102 -43.716646 -34513.768 -42206.078 -31383.641 -29951.584 2850.1184 3579.9253 5768.3698 + 10 11.52238 -45.959856 1.53397 0.085100522 0 0 1.6190706 -43.756903 -28644.676 -34867.94 -19324.955 -32842.522 -370.63233 -6452.0859 -4002.3535 + 20 20.237283 -46.772008 0.54762833 1.3835192 0 0 1.9311476 -43.815361 -10546.356 -10116.359 -17063.425 -6393.701 -1166.7608 4243.6327 3493.9596 + 30 20.666374 -45.011106 0.086797459 0.071122604 0 0 0.15792006 -43.805943 13150.762 15882.022 10964.553 10630.278 -6754.7642 -432.29165 -3783.115 + 40 10.639014 -45.430939 0.18926921 0.96410995 0 0 1.1533792 -43.738441 33402.664 41252.58 19726.586 38211.875 -6166.03 6081.5692 1815.7739 + 50 10.992432 -44.741108 0.19575431 0.25851128 0 0 0.45426559 -43.729815 37696.923 41572.466 33299.43 37168.141 -3254.5134 2.9639226 -1017.3669 + 60 19.748633 -45.461264 0.035287281 0.63217389 0 0 0.66746117 -43.793065 26212.839 28825.788 16048.096 31876.925 3504.5461 135.3505 420.28566 + 70 26.129957 -46.022729 0.30434543 0.56770169 0 0 0.87204711 -43.826579 3919.9866 -2755.6905 11500.428 517.54333 5626.9543 -2238.5786 86.305984 + 80 17.768494 -46.309777 1.1680612 0.45551823 0 0 1.6235794 -43.785801 -18335.898 -22168.789 -14488.992 -20048.346 7343.173 -2646.2196 -2525.6625 + 90 8.3822494 -47.063502 2.0182644 0.88875358 0 0 2.9070179 -43.731724 -33693.203 -43487.996 -15178.35 -43214.494 2412.6411 1993.0113 1780.7512 + 100 8.6486333 -46.517402 1.9551958 0.38696887 0 0 2.3421647 -43.736979 -34734.97 -34372.659 -28372.146 -42286.799 226.18821 40.353457 -755.93912 +Loop time of 0.0332539 on 4 procs for 100 steps with 18 atoms + +Performance: 259.819 ns/day, 0.092 hours/ns, 3007.165 timesteps/s +99.4% CPU use with 4 MPI tasks x no OpenMP threads + +HIPPO timing breakdown: + Init time: 0.000776397 2.52% + Repulse time: 0.00298646 9.69% + Disp time: 0.000570048 1.85% + Mpole time: 0.00370735 12.02% + Induce time: 0.0186844 60.59% + Polar time: 0.00372843 12.09% + Qxfer time: 0.000377474 1.22% + Total time: 0.0308356 + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.030832 | 0.031056 | 0.031379 | 0.1 | 93.39 +Bond | 7.9467e-05 | 9.2634e-05 | 0.00010651 | 0.0 | 0.28 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.00073586 | 0.0011119 | 0.001379 | 0.8 | 3.34 +Output | 0.00045718 | 0.00052546 | 0.00061508 | 0.0 | 1.58 +Modify | 3.7723e-05 | 5.1869e-05 | 6.5238e-05 | 0.0 | 0.16 +Other | | 0.000416 | | | 1.25 + +Nlocal: 4.5 ave 6 max 3 min +Histogram: 1 0 0 1 0 0 1 0 0 1 +Nghost: 13.5 ave 15 max 12 min +Histogram: 1 0 0 1 0 0 1 0 0 1 +Neighs: 38.25 ave 77 max 9 min +Histogram: 2 0 0 0 0 0 1 0 0 1 + +Total # of neighbors = 153 +Ave neighs/atom = 8.5 +Ave special neighs/atom = 2 +Neighbor list builds = 0 +Dangerous builds = 0 +Total wall time: 0:00:00 From f4ece2e82815d4db663ee12ec7e836274da87ca7 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Thu, 7 Jul 2022 15:02:48 -0600 Subject: [PATCH 546/585] change length of ubi run --- examples/amoeba/in.ubiquitin | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/examples/amoeba/in.ubiquitin b/examples/amoeba/in.ubiquitin index 21ce73bb25..4c47edfcfc 100644 --- a/examples/amoeba/in.ubiquitin +++ b/examples/amoeba/in.ubiquitin @@ -48,5 +48,5 @@ thermo_style custom step temp epair ebond eangle edihed eimp & fix 1 all nve -thermo 10 -run 100 +thermo 1 +run 10 From 87acd69b7126643b009d5fa5ad19248818c67160 Mon Sep 17 00:00:00 2001 From: rohskopf Date: Thu, 7 Jul 2022 16:44:57 -0600 Subject: [PATCH 547/585] More whitespace fixes --- src/ML-SNAP/compute_snap.cpp | 165 +++++++++++++++++------------------ 1 file changed, 82 insertions(+), 83 deletions(-) diff --git a/src/ML-SNAP/compute_snap.cpp b/src/ML-SNAP/compute_snap.cpp index 4c30aa4caa..515af28360 100644 --- a/src/ML-SNAP/compute_snap.cpp +++ b/src/ML-SNAP/compute_snap.cpp @@ -399,7 +399,7 @@ void ComputeSnap::compute_array() } } - // insure rij, inside, and typej are of size jnum + // insure rij, inside, and typej are of size jnum snaptr->grow_rij(jnum); @@ -455,89 +455,88 @@ void ComputeSnap::compute_array() // accumulate dBi/dRi, -dBi/dRj - if (!dgradflag) { + if (!dgradflag) { - double *snadi = snap_peratom[i]+typeoffset_local; - double *snadj = snap_peratom[j]+typeoffset_local; + double *snadi = snap_peratom[i]+typeoffset_local; + double *snadj = snap_peratom[j]+typeoffset_local; - for (int icoeff = 0; icoeff < ncoeff; icoeff++) { + for (int icoeff = 0; icoeff < ncoeff; icoeff++) { - snadi[icoeff] += snaptr->dblist[icoeff][0]; - snadi[icoeff+yoffset] += snaptr->dblist[icoeff][1]; - snadi[icoeff+zoffset] += snaptr->dblist[icoeff][2]; + snadi[icoeff] += snaptr->dblist[icoeff][0]; + snadi[icoeff+yoffset] += snaptr->dblist[icoeff][1]; + snadi[icoeff+zoffset] += snaptr->dblist[icoeff][2]; - snadj[icoeff] -= snaptr->dblist[icoeff][0]; - snadj[icoeff+yoffset] -= snaptr->dblist[icoeff][1]; - snadj[icoeff+zoffset] -= snaptr->dblist[icoeff][2]; - } + snadj[icoeff] -= snaptr->dblist[icoeff][0]; + snadj[icoeff+yoffset] -= snaptr->dblist[icoeff][1]; + snadj[icoeff+zoffset] -= snaptr->dblist[icoeff][2]; + } - if (quadraticflag) { - const int quadraticoffset = ncoeff; - snadi += quadraticoffset; - snadj += quadraticoffset; - int ncount = 0; - for (int icoeff = 0; icoeff < ncoeff; icoeff++) { - double bi = snaptr->blist[icoeff]; - double bix = snaptr->dblist[icoeff][0]; - double biy = snaptr->dblist[icoeff][1]; - double biz = snaptr->dblist[icoeff][2]; + if (quadraticflag) { + const int quadraticoffset = ncoeff; + snadi += quadraticoffset; + snadj += quadraticoffset; + int ncount = 0; + for (int icoeff = 0; icoeff < ncoeff; icoeff++) { + double bi = snaptr->blist[icoeff]; + double bix = snaptr->dblist[icoeff][0]; + double biy = snaptr->dblist[icoeff][1]; + double biz = snaptr->dblist[icoeff][2]; - // diagonal elements of quadratic matrix + // diagonal elements of quadratic matrix - double dbxtmp = bi*bix; - double dbytmp = bi*biy; - double dbztmp = bi*biz; + double dbxtmp = bi*bix; + double dbytmp = bi*biy; + double dbztmp = bi*biz; - snadi[ncount] += dbxtmp; - snadi[ncount+yoffset] += dbytmp; - snadi[ncount+zoffset] += dbztmp; - snadj[ncount] -= dbxtmp; - snadj[ncount+yoffset] -= dbytmp; - snadj[ncount+zoffset] -= dbztmp; + snadi[ncount] += dbxtmp; + snadi[ncount+yoffset] += dbytmp; + snadi[ncount+zoffset] += dbztmp; + snadj[ncount] -= dbxtmp; + snadj[ncount+yoffset] -= dbytmp; + snadj[ncount+zoffset] -= dbztmp; - ncount++; + ncount++; - // upper-triangular elements of quadratic matrix + // upper-triangular elements of quadratic matrix - for (int jcoeff = icoeff+1; jcoeff < ncoeff; jcoeff++) { - double dbxtmp = bi*snaptr->dblist[jcoeff][0] - + bix*snaptr->blist[jcoeff]; - double dbytmp = bi*snaptr->dblist[jcoeff][1] - + biy*snaptr->blist[jcoeff]; - double dbztmp = bi*snaptr->dblist[jcoeff][2] - + biz*snaptr->blist[jcoeff]; + for (int jcoeff = icoeff+1; jcoeff < ncoeff; jcoeff++) { + double dbxtmp = bi*snaptr->dblist[jcoeff][0] + + bix*snaptr->blist[jcoeff]; + double dbytmp = bi*snaptr->dblist[jcoeff][1] + + biy*snaptr->blist[jcoeff]; + double dbztmp = bi*snaptr->dblist[jcoeff][2] + + biz*snaptr->blist[jcoeff]; - snadi[ncount] += dbxtmp; - snadi[ncount+yoffset] += dbytmp; - snadi[ncount+zoffset] += dbztmp; - snadj[ncount] -= dbxtmp; - snadj[ncount+yoffset] -= dbytmp; - snadj[ncount+zoffset] -= dbztmp; + snadi[ncount] += dbxtmp; + snadi[ncount+yoffset] += dbytmp; + snadi[ncount+zoffset] += dbztmp; + snadj[ncount] -= dbxtmp; + snadj[ncount+yoffset] -= dbytmp; + snadj[ncount+zoffset] -= dbztmp; - ncount++; - } - } - } - } else { + ncount++; + } + } + } + } else { - for (int icoeff = 0; icoeff < ncoeff; icoeff++) { + for (int icoeff = 0; icoeff < ncoeff; icoeff++) { - // add to snap array for this proc + // add to snap array for this proc - // dBi/dRj + // dBi/dRj - snap[bik_rows + ((atom->tag[j]-1)*3*natoms) + 3*(atom->tag[i]-1) + 0][icoeff+3] -= snaptr->dblist[icoeff][0]; - snap[bik_rows + ((atom->tag[j]-1)*3*natoms) + 3*(atom->tag[i]-1) + 1][icoeff+3] -= snaptr->dblist[icoeff][1]; - snap[bik_rows + ((atom->tag[j]-1)*3*natoms) + 3*(atom->tag[i]-1) + 2][icoeff+3] -= snaptr->dblist[icoeff][2]; + snap[bik_rows + ((atom->tag[j]-1)*3*natoms) + 3*(atom->tag[i]-1) + 0][icoeff+3] -= snaptr->dblist[icoeff][0]; + snap[bik_rows + ((atom->tag[j]-1)*3*natoms) + 3*(atom->tag[i]-1) + 1][icoeff+3] -= snaptr->dblist[icoeff][1]; + snap[bik_rows + ((atom->tag[j]-1)*3*natoms) + 3*(atom->tag[i]-1) + 2][icoeff+3] -= snaptr->dblist[icoeff][2]; - // dBi/dRi + // dBi/dRi - snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 0][icoeff+3] += snaptr->dblist[icoeff][0]; - snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 1][icoeff+3] += snaptr->dblist[icoeff][1]; - snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 2][icoeff+3] += snaptr->dblist[icoeff][2]; - } - - } + snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 0][icoeff+3] += snaptr->dblist[icoeff][0]; + snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 1][icoeff+3] += snaptr->dblist[icoeff][1]; + snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 2][icoeff+3] += snaptr->dblist[icoeff][2]; + } + } } // loop over jj inside @@ -545,31 +544,31 @@ void ComputeSnap::compute_array() if (!dgradflag) { - // linear contributions + // linear contributions - int k = typeoffset_global; + int k = typeoffset_global; for (int icoeff = 0; icoeff < ncoeff; icoeff++) snap[irow][k++] += snaptr->blist[icoeff]; - // quadratic contributions + // quadratic contributions - if (quadraticflag) { - for (int icoeff = 0; icoeff < ncoeff; icoeff++) { - double bveci = snaptr->blist[icoeff]; - snap[irow][k++] += 0.5*bveci*bveci; - for (int jcoeff = icoeff+1; jcoeff < ncoeff; jcoeff++) { - double bvecj = snaptr->blist[jcoeff]; - snap[irow][k++] += bveci*bvecj; - } - } - } + if (quadraticflag) { + for (int icoeff = 0; icoeff < ncoeff; icoeff++) { + double bveci = snaptr->blist[icoeff]; + snap[irow][k++] += 0.5*bveci*bveci; + for (int jcoeff = icoeff+1; jcoeff < ncoeff; jcoeff++) { + double bvecj = snaptr->blist[jcoeff]; + snap[irow][k++] += bveci*bvecj; + } + } + } } else { - int k = 3; - for (int icoeff = 0; icoeff < ncoeff; icoeff++) - snap[irow][k++] += snaptr->blist[icoeff]; - numneigh_sum += ninside; - } + int k = 3; + for (int icoeff = 0; icoeff < ncoeff; icoeff++) + snap[irow][k++] += snaptr->blist[icoeff]; + numneigh_sum += ninside; + } } // if (mask[i] & groupbit) From de274cddefe36a87d7ef92248870b451af429c0a Mon Sep 17 00:00:00 2001 From: Stan Gerald Moore Date: Thu, 7 Jul 2022 16:48:03 -0600 Subject: [PATCH 548/585] Add pair_modify option to allow separate cutoffs for each neigh list with pair hybrid/overlay --- doc/src/pair_modify.rst | 25 +++- src/KOKKOS/Install.sh | 2 + src/KOKKOS/npair_halffull_kokkos.cpp | 54 ++++++-- src/KOKKOS/npair_halffull_kokkos.h | 147 +++++++++++++++++--- src/KOKKOS/npair_trim_kokkos.cpp | 196 +++++++++++++++++++++++++++ src/KOKKOS/npair_trim_kokkos.h | 70 ++++++++++ src/neigh_list.cpp | 5 +- src/neigh_list.h | 1 + src/neigh_request.cpp | 1 + src/neigh_request.h | 1 + src/neighbor.cpp | 150 +++++++++++++++----- src/neighbor.h | 8 +- src/npair_halffull_newtoff_trim.cpp | 101 ++++++++++++++ src/npair_halffull_newtoff_trim.h | 54 ++++++++ src/npair_halffull_newton_trim.cpp | 108 +++++++++++++++ src/npair_halffull_newton_trim.h | 44 ++++++ src/npair_trim.cpp | 92 +++++++++++++ src/npair_trim.h | 38 ++++++ src/pair.cpp | 4 + src/pair.h | 1 + src/pair_hybrid.cpp | 30 +++- src/pair_hybrid.h | 10 +- 22 files changed, 1069 insertions(+), 73 deletions(-) create mode 100644 src/KOKKOS/npair_trim_kokkos.cpp create mode 100644 src/KOKKOS/npair_trim_kokkos.h create mode 100644 src/npair_halffull_newtoff_trim.cpp create mode 100644 src/npair_halffull_newtoff_trim.h create mode 100644 src/npair_halffull_newton_trim.cpp create mode 100644 src/npair_halffull_newton_trim.h create mode 100644 src/npair_trim.cpp create mode 100644 src/npair_trim.h diff --git a/doc/src/pair_modify.rst b/doc/src/pair_modify.rst index 4941693fbd..506867f2a3 100644 --- a/doc/src/pair_modify.rst +++ b/doc/src/pair_modify.rst @@ -13,7 +13,7 @@ Syntax * one or more keyword/value pairs may be listed * keyword = *pair* or *shift* or *mix* or *table* or *table/disp* or *tabinner* or *tabinner/disp* or *tail* or *compute* or *nofdotr* or *special* or - *compute/tally* + *compute/tally* or *neigh/trim* .. parsed-literal:: @@ -37,6 +37,7 @@ Syntax which = *lj/coul* or *lj* or *coul* w1,w2,w3 = 1-2, 1-3, 1-4 weights from 0.0 to 1.0 inclusive *compute/tally* value = *yes* or *no* + *neigh/trim* value = *yes* or *no* Examples """""""" @@ -283,6 +284,26 @@ the *pair* keyword. Use *no* to disable, or *yes* to enable. The "pair_modify pair compute/tally" command must be issued **before** the corresponding compute style is defined. +The *neigh/trim* keyword controls whether an explicit cutoff is set +for each neighbor list requested by the individual pair sub-styles +when using :doc:`pair hybrid\*/overlay `. When +this keyword is set to *no*, then the cutoff of the pair sub-style +neighbor will be set to the master list distance, and if possible the +neighbor list will be copied directly from another list. When this +keyword is set to *yes* then the cutoff of the neighbor list will be +explicitly set to the value requested by the pair sub-style, and if +possible the list will be created by trimming from another list with a +longer cutoff, otherwise a new neighbor list will be created with the +specified cutoff. The *yes* option can be faster when there are +multiple pair styles with different cutoffs since the number of +pair-wise distance checks between neighbors is reduced (but the time +required to build the neighbor lists is increased). + +.. note:: + + The "pair_modify neigh/trim" command only applies when there are + multiple pair sub-styles, i.e. when using pair hybrid/overlay + ---------- Restrictions @@ -304,7 +325,7 @@ Default """"""" The option defaults are mix = geometric, shift = no, table = 12, -tabinner = sqrt(2.0), tail = no, and compute = yes. +tabinner = sqrt(2.0), tail = no, compute = yes, and neigh/trim no. Note that some pair styles perform mixing, but only a certain style of mixing. See the doc pages for individual pair styles for details. diff --git a/src/KOKKOS/Install.sh b/src/KOKKOS/Install.sh index 314205ea3e..6ad96be466 100755 --- a/src/KOKKOS/Install.sh +++ b/src/KOKKOS/Install.sh @@ -204,6 +204,8 @@ action npair_halffull_kokkos.cpp action npair_halffull_kokkos.h action npair_skip_kokkos.cpp action npair_skip_kokkos.h +action npair_trim_kokkos.cpp +action npair_trim_kokkos.h action npair_kokkos.cpp action npair_kokkos.h action npair_ssa_kokkos.cpp npair_half_bin_newton_ssa.cpp diff --git a/src/KOKKOS/npair_halffull_kokkos.cpp b/src/KOKKOS/npair_halffull_kokkos.cpp index 53bd132cac..3005f0e463 100644 --- a/src/KOKKOS/npair_halffull_kokkos.cpp +++ b/src/KOKKOS/npair_halffull_kokkos.cpp @@ -26,8 +26,8 @@ using namespace LAMMPS_NS; /* ---------------------------------------------------------------------- */ -template -NPairHalffullKokkos::NPairHalffullKokkos(LAMMPS *lmp) : NPair(lmp) { +template +NPairHalffullKokkos::NPairHalffullKokkos(LAMMPS *lmp) : NPair(lmp) { atomKK = (AtomKokkos *) atom; execution_space = ExecutionSpaceFromDevice::space; } @@ -41,15 +41,17 @@ NPairHalffullKokkos::NPairHalffullKokkos(LAMMPS *lmp) : NPair if ghost, also store neighbors of ghost atoms & set inum,gnum correctly ------------------------------------------------------------------------- */ -template -void NPairHalffullKokkos::build(NeighList *list) +template +void NPairHalffullKokkos::build(NeighList *list) { - if (NEWTON) { + if (NEWTON || TRIM) { x = atomKK->k_x.view(); atomKK->sync(execution_space,X_MASK); } nlocal = atom->nlocal; + cutsq_custom = cutoff_custom*cutoff_custom; + NeighListKokkos* k_list_full = static_cast*>(list->listfull); d_ilist_full = k_list_full->d_ilist; d_numneigh_full = k_list_full->d_numneigh; @@ -76,14 +78,14 @@ void NPairHalffullKokkos::build(NeighList *list) k_list->k_ilist.template modify(); } -template +template KOKKOS_INLINE_FUNCTION -void NPairHalffullKokkos::operator()(TagNPairHalffullCompute, const int &ii) const { +void NPairHalffullKokkos::operator()(TagNPairHalffullCompute, const int &ii) const { int n = 0; const int i = d_ilist_full(ii); F_FLOAT xtmp,ytmp,ztmp; - if (NEWTON) { + if (NEWTON || TRIM) { xtmp = x(i,0); ytmp = x(i,1); ztmp = x(i,2); @@ -108,9 +110,29 @@ void NPairHalffullKokkos::operator()(TagNPairHalffullCompute, if (x(j,1) == ytmp && x(j,0) < xtmp) continue; } } + + if (TRIM) { + const double delx = xtmp - x(j,0); + const double dely = ytmp - x(j,1); + const double delz = ztmp - x(j,2); + const double rsq = delx*delx + dely*dely + delz*delz; + + if (rsq > cutsq_custom) continue; + } + + neighbors_i(n++) = joriginal; + } else if (j > i) { + + if (TRIM) { + const double delx = xtmp - x(j,0); + const double dely = ytmp - x(j,1); + const double delz = ztmp - x(j,2); + const double rsq = delx*delx + dely*dely + delz*delz; + + if (rsq > cutsq_custom) continue; + } + neighbors_i(n++) = joriginal; - } else { - if (j > i) neighbors_i(n++) = joriginal; } } @@ -119,10 +141,14 @@ void NPairHalffullKokkos::operator()(TagNPairHalffullCompute, } namespace LAMMPS_NS { -template class NPairHalffullKokkos; -template class NPairHalffullKokkos; +template class NPairHalffullKokkos; +template class NPairHalffullKokkos; +template class NPairHalffullKokkos; +template class NPairHalffullKokkos; #ifdef LMP_KOKKOS_GPU -template class NPairHalffullKokkos; -template class NPairHalffullKokkos; +template class NPairHalffullKokkos; +template class NPairHalffullKokkos; +template class NPairHalffullKokkos; +template class NPairHalffullKokkos; #endif } diff --git a/src/KOKKOS/npair_halffull_kokkos.h b/src/KOKKOS/npair_halffull_kokkos.h index 6d4e722098..ce2321f6fd 100644 --- a/src/KOKKOS/npair_halffull_kokkos.h +++ b/src/KOKKOS/npair_halffull_kokkos.h @@ -13,27 +13,30 @@ #ifdef NPAIR_CLASS // clang-format off + +// Trim off + // Newton -typedef NPairHalffullKokkos NPairKokkosHalffullNewtonDevice; +typedef NPairHalffullKokkos NPairKokkosHalffullNewtonDevice; NPairStyle(halffull/newton/kk/device, NPairKokkosHalffullNewtonDevice, NP_HALF_FULL | NP_NEWTON | NP_HALF | NP_NSQ | NP_BIN | NP_MULTI | NP_ORTHO | NP_TRI | NP_KOKKOS_DEVICE); -typedef NPairHalffullKokkos NPairKokkosHalffullNewtonHost; +typedef NPairHalffullKokkos NPairKokkosHalffullNewtonHost; NPairStyle(halffull/newton/kk/host, NPairKokkosHalffullNewtonHost, NP_HALF_FULL | NP_NEWTON | NP_HALF | NP_NSQ | NP_BIN | NP_MULTI | NP_ORTHO | NP_TRI | NP_KOKKOS_HOST); -typedef NPairHalffullKokkos NPairKokkosHalffullNewtonDevice; +typedef NPairHalffullKokkos NPairKokkosHalffullNewtonDevice; NPairStyle(halffull/newton/skip/kk/device, NPairKokkosHalffullNewtonDevice, NP_HALF_FULL | NP_NEWTON | NP_HALF | NP_NSQ | NP_BIN | NP_MULTI | NP_ORTHO | NP_TRI | NP_SKIP | NP_KOKKOS_DEVICE); -typedef NPairHalffullKokkos NPairKokkosHalffullNewtonHost; +typedef NPairHalffullKokkos NPairKokkosHalffullNewtonHost; NPairStyle(halffull/newton/skip/kk/host, NPairKokkosHalffullNewtonHost, NP_HALF_FULL | NP_NEWTON | NP_HALF | NP_NSQ | NP_BIN | NP_MULTI | @@ -41,25 +44,25 @@ NPairStyle(halffull/newton/skip/kk/host, // Newtoff -typedef NPairHalffullKokkos NPairKokkosHalffullNewtoffDevice; +typedef NPairHalffullKokkos NPairKokkosHalffullNewtoffDevice; NPairStyle(halffull/newtoff/kk/device, NPairKokkosHalffullNewtoffDevice, NP_HALF_FULL | NP_NEWTOFF | NP_HALF | NP_NSQ | NP_BIN | NP_MULTI | NP_ORTHO | NP_TRI | NP_KOKKOS_DEVICE); -typedef NPairHalffullKokkos NPairKokkosHalffullNewtoffHost; +typedef NPairHalffullKokkos NPairKokkosHalffullNewtoffHost; NPairStyle(halffull/newtoff/kk/host, NPairKokkosHalffullNewtoffHost, NP_HALF_FULL | NP_NEWTOFF | NP_HALF | NP_NSQ | NP_BIN | NP_MULTI | NP_ORTHO | NP_TRI | NP_KOKKOS_HOST); -typedef NPairHalffullKokkos NPairKokkosHalffullNewtoffDevice; +typedef NPairHalffullKokkos NPairKokkosHalffullNewtoffDevice; NPairStyle(halffull/newtoff/skip/kk/device, NPairKokkosHalffullNewtoffDevice, NP_HALF_FULL | NP_NEWTOFF | NP_HALF | NP_NSQ | NP_BIN | NP_MULTI | NP_ORTHO | NP_TRI | NP_SKIP | NP_KOKKOS_DEVICE); -typedef NPairHalffullKokkos NPairKokkosHalffullNewtoffHost; +typedef NPairHalffullKokkos NPairKokkosHalffullNewtoffHost; NPairStyle(halffull/newtoff/skip/kk/host, NPairKokkosHalffullNewtoffHost, NP_HALF_FULL | NP_NEWTOFF | NP_HALF | NP_NSQ | NP_BIN | NP_MULTI | @@ -69,25 +72,25 @@ NPairStyle(halffull/newtoff/skip/kk/host, // Newton -typedef NPairHalffullKokkos NPairKokkosHalffullNewtonGhostDevice; +typedef NPairHalffullKokkos NPairKokkosHalffullNewtonGhostDevice; NPairStyle(halffull/newton/ghost/kk/device, NPairKokkosHalffullNewtonGhostDevice, NP_HALF_FULL | NP_NEWTON | NP_HALF | NP_NSQ | NP_BIN | NP_MULTI | NP_ORTHO | NP_TRI | NP_GHOST | NP_KOKKOS_DEVICE); -typedef NPairHalffullKokkos NPairKokkosHalffullNewtonHost; +typedef NPairHalffullKokkos NPairKokkosHalffullNewtonHost; NPairStyle(halffull/newton/ghost/kk/host, NPairKokkosHalffullNewtonHost, NP_HALF_FULL | NP_NEWTON | NP_HALF | NP_NSQ | NP_BIN | NP_MULTI | NP_ORTHO | NP_TRI | NP_GHOST | NP_KOKKOS_HOST); -typedef NPairHalffullKokkos NPairKokkosHalffullNewtonGhostDevice; +typedef NPairHalffullKokkos NPairKokkosHalffullNewtonGhostDevice; NPairStyle(halffull/newton/skip/ghost/kk/device, NPairKokkosHalffullNewtonGhostDevice, NP_HALF_FULL | NP_NEWTON | NP_HALF | NP_NSQ | NP_BIN | NP_MULTI | NP_ORTHO | NP_TRI | NP_GHOST | NP_SKIP | NP_KOKKOS_DEVICE); -typedef NPairHalffullKokkos NPairKokkosHalffullNewtonHost; +typedef NPairHalffullKokkos NPairKokkosHalffullNewtonHost; NPairStyle(halffull/newton/skip/ghost/kk/host, NPairKokkosHalffullNewtonHost, NP_HALF_FULL | NP_NEWTON | NP_HALF | NP_NSQ | NP_BIN | NP_MULTI | @@ -95,29 +98,138 @@ NPairStyle(halffull/newton/skip/ghost/kk/host, // Newtoff -typedef NPairHalffullKokkos NPairKokkosHalffullNewtoffGhostDevice; +typedef NPairHalffullKokkos NPairKokkosHalffullNewtoffGhostDevice; NPairStyle(halffull/newtoff/ghost/kk/device, NPairKokkosHalffullNewtoffGhostDevice, NP_HALF_FULL | NP_NEWTOFF | NP_HALF | NP_NSQ | NP_BIN | NP_MULTI | NP_ORTHO | NP_TRI | NP_GHOST | NP_KOKKOS_DEVICE); -typedef NPairHalffullKokkos NPairKokkosHalffullNewtoffHost; +typedef NPairHalffullKokkos NPairKokkosHalffullNewtoffHost; NPairStyle(halffull/newtoff/ghost/kk/host, NPairKokkosHalffullNewtoffHost, NP_HALF_FULL | NP_NEWTOFF | NP_HALF | NP_NSQ | NP_BIN | NP_MULTI | NP_ORTHO | NP_TRI | NP_GHOST | NP_KOKKOS_HOST); -typedef NPairHalffullKokkos NPairKokkosHalffullNewtoffGhostDevice; +typedef NPairHalffullKokkos NPairKokkosHalffullNewtoffGhostDevice; NPairStyle(halffull/newtoff/skip/ghost/kk/device, NPairKokkosHalffullNewtoffGhostDevice, NP_HALF_FULL | NP_NEWTOFF | NP_HALF | NP_NSQ | NP_BIN | NP_MULTI | NP_ORTHO | NP_TRI | NP_GHOST | NP_SKIP | NP_KOKKOS_DEVICE); -typedef NPairHalffullKokkos NPairKokkosHalffullNewtoffHost; +typedef NPairHalffullKokkos NPairKokkosHalffullNewtoffHost; NPairStyle(halffull/newtoff/skip/ghost/kk/host, NPairKokkosHalffullNewtoffHost, NP_HALF_FULL | NP_NEWTOFF | NP_HALF | NP_NSQ | NP_BIN | NP_MULTI | NP_ORTHO | NP_TRI | NP_GHOST | NP_SKIP | NP_KOKKOS_HOST); + + +//************ Trim ************** + +// Newton + +typedef NPairHalffullKokkos NPairKokkosHalffullNewtonTrimDevice; +NPairStyle(halffull/newton/trim/kk/device, + NPairKokkosHalffullNewtonTrimDevice, + NP_HALF_FULL | NP_NEWTON | NP_HALF | NP_NSQ | NP_BIN | NP_MULTI | + NP_ORTHO | NP_TRI | NP_TRIM | NP_KOKKOS_DEVICE); + +typedef NPairHalffullKokkos NPairKokkosHalffullNewtonTrimHost; +NPairStyle(halffull/newton/trim/kk/host, + NPairKokkosHalffullNewtonTrimHost, + NP_HALF_FULL | NP_NEWTON | NP_HALF | NP_NSQ | NP_BIN | NP_MULTI | + NP_ORTHO | NP_TRI | NP_TRIM | NP_KOKKOS_HOST); + +typedef NPairHalffullKokkos NPairKokkosHalffullNewtonTrimDevice; +NPairStyle(halffull/newton/skip/trim/kk/device, + NPairKokkosHalffullNewtonTrimDevice, + NP_HALF_FULL | NP_NEWTON | NP_HALF | NP_NSQ | NP_BIN | NP_MULTI | + NP_ORTHO | NP_TRI | NP_SKIP | NP_TRIM | NP_KOKKOS_DEVICE); + +typedef NPairHalffullKokkos NPairKokkosHalffullNewtonTrimHost; +NPairStyle(halffull/newton/skip/trim/kk/host, + NPairKokkosHalffullNewtonTrimHost, + NP_HALF_FULL | NP_NEWTON | NP_HALF | NP_NSQ | NP_BIN | NP_MULTI | + NP_ORTHO | NP_TRI | NP_SKIP | NP_TRIM | NP_KOKKOS_HOST); + +// Newtoff + +typedef NPairHalffullKokkos NPairKokkosHalffullNewtoffTrimDevice; +NPairStyle(halffull/newtoff/trim/kk/device, + NPairKokkosHalffullNewtoffTrimDevice, + NP_HALF_FULL | NP_NEWTOFF | NP_HALF | NP_NSQ | NP_BIN | NP_MULTI | + NP_ORTHO | NP_TRI | NP_TRIM | NP_KOKKOS_DEVICE); + +typedef NPairHalffullKokkos NPairKokkosHalffullNewtoffTrimHost; +NPairStyle(halffull/newtoff/trim/kk/host, + NPairKokkosHalffullNewtoffTrimHost, + NP_HALF_FULL | NP_NEWTOFF | NP_HALF | NP_NSQ | NP_BIN | NP_MULTI | + NP_ORTHO | NP_TRI | NP_TRIM | NP_KOKKOS_HOST); + +typedef NPairHalffullKokkos NPairKokkosHalffullNewtoffTrimDevice; +NPairStyle(halffull/newtoff/skip/trim/kk/device, + NPairKokkosHalffullNewtoffTrimDevice, + NP_HALF_FULL | NP_NEWTOFF | NP_HALF | NP_NSQ | NP_BIN | NP_MULTI | + NP_ORTHO | NP_TRI | NP_SKIP | NP_TRIM | NP_KOKKOS_DEVICE); + +typedef NPairHalffullKokkos NPairKokkosHalffullNewtoffTrimHost; +NPairStyle(halffull/newtoff/skip/trim/kk/host, + NPairKokkosHalffullNewtoffTrimHost, + NP_HALF_FULL | NP_NEWTOFF | NP_HALF | NP_NSQ | NP_BIN | NP_MULTI | + NP_ORTHO | NP_TRI | NP_SKIP | NP_TRIM | NP_KOKKOS_HOST); + +//************ Ghost ************** + +// Newton + +typedef NPairHalffullKokkos NPairKokkosHalffullNewtonGhostTrimDevice; +NPairStyle(halffull/newton/ghost/trim/kk/device, + NPairKokkosHalffullNewtonGhostTrimDevice, + NP_HALF_FULL | NP_NEWTON | NP_HALF | NP_NSQ | NP_BIN | NP_MULTI | + NP_ORTHO | NP_TRI | NP_GHOST | NP_TRIM | NP_KOKKOS_DEVICE); + +typedef NPairHalffullKokkos NPairKokkosHalffullNewtonTrimHost; +NPairStyle(halffull/newton/ghost/trim/kk/host, + NPairKokkosHalffullNewtonTrimHost, + NP_HALF_FULL | NP_NEWTON | NP_HALF | NP_NSQ | NP_BIN | NP_MULTI | + NP_ORTHO | NP_TRI | NP_GHOST | NP_TRIM | NP_KOKKOS_HOST); + +typedef NPairHalffullKokkos NPairKokkosHalffullNewtonGhostTrimDevice; +NPairStyle(halffull/newton/skip/ghost/trim/kk/device, + NPairKokkosHalffullNewtonGhostTrimDevice, + NP_HALF_FULL | NP_NEWTON | NP_HALF | NP_NSQ | NP_BIN | NP_MULTI | + NP_ORTHO | NP_TRI | NP_GHOST | NP_SKIP | NP_TRIM | NP_KOKKOS_DEVICE); + +typedef NPairHalffullKokkos NPairKokkosHalffullNewtonTrimHost; +NPairStyle(halffull/newton/skip/ghost/trim/kk/host, + NPairKokkosHalffullNewtonTrimHost, + NP_HALF_FULL | NP_NEWTON | NP_HALF | NP_NSQ | NP_BIN | NP_MULTI | + NP_ORTHO | NP_TRI | NP_GHOST | NP_SKIP | NP_TRIM | NP_KOKKOS_HOST); + +// Newtoff + +typedef NPairHalffullKokkos NPairKokkosHalffullNewtoffGhostTrimDevice; +NPairStyle(halffull/newtoff/ghost/trim/kk/device, + NPairKokkosHalffullNewtoffGhostTrimDevice, + NP_HALF_FULL | NP_NEWTOFF | NP_HALF | NP_NSQ | NP_BIN | NP_MULTI | + NP_ORTHO | NP_TRI | NP_GHOST | NP_TRIM | NP_KOKKOS_DEVICE); + +typedef NPairHalffullKokkos NPairKokkosHalffullNewtoffTrimHost; +NPairStyle(halffull/newtoff/ghost/trim/kk/host, + NPairKokkosHalffullNewtoffTrimHost, + NP_HALF_FULL | NP_NEWTOFF | NP_HALF | NP_NSQ | NP_BIN | NP_MULTI | + NP_ORTHO | NP_TRI | NP_GHOST | NP_TRIM | NP_KOKKOS_HOST); + +typedef NPairHalffullKokkos NPairKokkosHalffullNewtoffGhostTrimDevice; +NPairStyle(halffull/newtoff/skip/ghost/trim/kk/device, + NPairKokkosHalffullNewtoffGhostTrimDevice, + NP_HALF_FULL | NP_NEWTOFF | NP_HALF | NP_NSQ | NP_BIN | NP_MULTI | + NP_ORTHO | NP_TRI | NP_GHOST | NP_SKIP | NP_TRIM | NP_KOKKOS_DEVICE); + +typedef NPairHalffullKokkos NPairKokkosHalffullNewtoffTrimHost; +NPairStyle(halffull/newtoff/skip/ghost/trim/kk/host, + NPairKokkosHalffullNewtoffTrimHost, + NP_HALF_FULL | NP_NEWTOFF | NP_HALF | NP_NSQ | NP_BIN | NP_MULTI | + NP_ORTHO | NP_TRI | NP_GHOST | NP_SKIP | NP_TRIM | NP_KOKKOS_HOST); // clang-format on #else @@ -132,7 +244,7 @@ namespace LAMMPS_NS { struct TagNPairHalffullCompute{}; -template +template class NPairHalffullKokkos : public NPair { public: typedef DeviceType device_type; @@ -146,6 +258,7 @@ class NPairHalffullKokkos : public NPair { private: int nlocal; + double cutsq_custom; typename AT::t_x_array_randomread x; diff --git a/src/KOKKOS/npair_trim_kokkos.cpp b/src/KOKKOS/npair_trim_kokkos.cpp new file mode 100644 index 0000000000..bd2761f40c --- /dev/null +++ b/src/KOKKOS/npair_trim_kokkos.cpp @@ -0,0 +1,196 @@ +// clang-format off +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + https://www.lammps.org/, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Trimright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#include "npair_trim_kokkos.h" +#include "atom_kokkos.h" +#include "atom_masks.h" +#include "neigh_list_kokkos.h" +#include "my_page.h" +#include "error.h" + +using namespace LAMMPS_NS; + +/* ---------------------------------------------------------------------- */ + +template +NPairTrimKokkos::NPairTrimKokkos(LAMMPS *lmp) : NPair(lmp) {} + +/* ---------------------------------------------------------------------- + create list which is simply a copy of parent list +------------------------------------------------------------------------- */ + +template +void NPairTrimKokkos::build(NeighList *list) +{ + NeighList *listcopy = list->listcopy; + + cutsq_custom = cutoff_custom*cutoff_custom; + + if (list->kokkos) { + if (!listcopy->kokkos) + error->all(FLERR,"Cannot trim non-Kokkos neighbor list to Kokkos neighbor list"); + trim_to_kokkos(list); + } else { + if (!listcopy->kokkos) + error->all(FLERR,"Missing Kokkos neighbor list for trim"); + trim_to_cpu(list); + } +} + +/* ---------------------------------------------------------------------- */ + +template +void NPairTrimKokkos::trim_to_kokkos(NeighList *list) +{ + x = atomKK->k_x.view(); + atomKK->sync(execution_space,X_MASK); + + cutsq_custom = cutoff_custom*cutoff_custom; + + NeighListKokkos* k_list_copy = static_cast*>(list->listcopy); + d_ilist_copy = k_list_copy->d_ilist; + d_numneigh_copy = k_list_copy->d_numneigh; + d_neighbors_copy = k_list_copy->d_neighbors; + int inum_copy = list->listcopy->inum; + if (list->ghost) inum_copy += list->listcopy->gnum; + + NeighListKokkos* k_list = static_cast*>(list); + k_list->maxneighs = k_list_copy->maxneighs; // simple, but could be made more memory efficient + k_list->grow(atom->nmax); + d_ilist = k_list->d_ilist; + d_numneigh = k_list->d_numneigh; + d_neighbors = k_list->d_neighbors; + + // loop over parent list and trim + + copymode = 1; + Kokkos::parallel_for(Kokkos::RangePolicy(0,inum_copy),*this); + copymode = 0; + + list->inum = k_list_copy->inum; + list->gnum = k_list_copy->gnum; + + k_list->k_ilist.template modify(); +} + +template +KOKKOS_INLINE_FUNCTION +void NPairTrimKokkos::operator()(TagNPairTrim, const int &ii) const { + int n = 0; + + const int i = d_ilist_copy(ii); + const double xtmp = x(i,0); + const double ytmp = x(i,1); + const double ztmp = x(i,2); + + // loop over copy neighbor list + + const int jnum = d_numneigh_copy(i); + const AtomNeighbors neighbors_i = AtomNeighbors(&d_neighbors(i,0),d_numneigh(i), + &d_neighbors(i,1)-&d_neighbors(i,0)); + + for (int jj = 0; jj < jnum; jj++) { + const int joriginal = d_neighbors_copy(i,jj); + const int j = joriginal & NEIGHMASK; + + const double delx = xtmp - x(j,0); + const double dely = ytmp - x(j,1); + const double delz = ztmp - x(j,2); + const double rsq = delx*delx + dely*dely + delz*delz; + + if (rsq > cutsq_custom) continue; + + neighbors_i(n++) = joriginal; + } + + d_numneigh(i) = n; + d_ilist(ii) = i; +} + +/* ---------------------------------------------------------------------- */ + +template +void NPairTrimKokkos::trim_to_cpu(NeighList *list) +{ + NeighList *listcopy = list->listcopy; + NeighListKokkos* listcopy_kk = (NeighListKokkos*) listcopy; + + listcopy_kk->k_ilist.template sync(); + + double** x = atom->x; + + int inum = listcopy->inum; + int gnum = listcopy->gnum; + int inum_all = inum; + if (list->ghost) inum_all += gnum; + auto h_ilist = listcopy_kk->k_ilist.h_view; + auto h_numneigh = Kokkos::create_mirror_view_and_copy(LMPHostType(),listcopy_kk->d_numneigh); + auto h_neighbors = Kokkos::create_mirror_view_and_copy(LMPHostType(),listcopy_kk->d_neighbors); + + list->inum = inum; + list->gnum = gnum; + auto ilist = list->ilist; + auto numneigh = list->numneigh; + + // Kokkos neighbor data is stored differently than regular CPU, + // must loop over lists + + int *neighptr; + int **firstneigh = list->firstneigh; + MyPage *ipage = list->ipage; + ipage->reset(); + + for (int ii = 0; ii < inum_all; ii++) { + int n = 0; + neighptr = ipage->vget(); + + const int i = h_ilist[ii]; + ilist[ii] = i; + const double xtmp = x[i][0]; + const double ytmp = x[i][1]; + const double ztmp = x[i][2]; + + // loop over Kokkos neighbor list + + const int jnum = h_numneigh[i]; + + for (int jj = 0; jj < jnum; jj++) { + const int joriginal = h_neighbors(i,jj); + + const int j = joriginal & NEIGHMASK; + + const double delx = xtmp - x[j][0]; + const double dely = ytmp - x[j][1]; + const double delz = ztmp - x[j][2]; + const double rsq = delx*delx + dely*dely + delz*delz; + + if (rsq > cutsq_custom) continue; + + neighptr[n++] = joriginal; + } + + firstneigh[i] = neighptr; + numneigh[i] = n; + ipage->vgot(n); + if (ipage->status()) + error->one(FLERR,"Neighbor list overflow, boost neigh_modify one"); + } +} + +namespace LAMMPS_NS { +template class NPairTrimKokkos; +#ifdef LMP_KOKKOS_GPU +template class NPairTrimKokkos; +#endif +} diff --git a/src/KOKKOS/npair_trim_kokkos.h b/src/KOKKOS/npair_trim_kokkos.h new file mode 100644 index 0000000000..67b60f7337 --- /dev/null +++ b/src/KOKKOS/npair_trim_kokkos.h @@ -0,0 +1,70 @@ +/* -*- c++ -*- ---------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + https://www.lammps.org/, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Trimright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#ifdef NPAIR_CLASS +// clang-format off +NPairStyle(trim/kk/device, + NPairTrimKokkos, + NP_COPY | NP_TRIM | NP_KOKKOS_DEVICE); + +NPairStyle(trim/kk/host, + NPairTrimKokkos, + NP_COPY | NP_TRIM | NP_KOKKOS_HOST); +// clang-format on +#else + +// clang-format off +#ifndef LMP_NPAIR_TRIM_KOKKOS_H +#define LMP_NPAIR_TRIM_KOKKOS_H + +#include "npair.h" +#include "kokkos_type.h" + +namespace LAMMPS_NS { + +struct TagNPairTrim{}; + +template +class NPairTrimKokkos : public NPair { + public: + typedef DeviceType device_type; + typedef ArrayTypes AT; + + NPairTrimKokkos(class LAMMPS *); + void build(class NeighList *) override; + + KOKKOS_INLINE_FUNCTION + void operator()(TagNPairTrim, const int&) const; + + private: + double cutsq_custom; + + typename AT::t_x_array_randomread x; + + typename AT::t_neighbors_2d_const d_neighbors_copy; + typename AT::t_int_1d_const d_ilist_copy; + typename AT::t_int_1d_const d_numneigh_copy; + + typename AT::t_neighbors_2d d_neighbors; + typename AT::t_int_1d d_ilist; + typename AT::t_int_1d d_numneigh; + + void trim_to_kokkos(class NeighList *); + void trim_to_cpu(class NeighList *); +}; + +} + +#endif +#endif + diff --git a/src/neigh_list.cpp b/src/neigh_list.cpp index dc76b242e9..3fbbd81d2e 100644 --- a/src/neigh_list.cpp +++ b/src/neigh_list.cpp @@ -48,6 +48,7 @@ NeighList::NeighList(LAMMPS *lmp) : Pointers(lmp) respamiddle = 0; respainner = 0; copy = 0; + trim = 0; copymode = 0; // ptrs @@ -97,7 +98,8 @@ NeighList::NeighList(LAMMPS *lmp) : Pointers(lmp) NeighList::~NeighList() { if (copymode) return; - if (!copy) { + + if (!copy || trim || kk2cpu) { memory->destroy(ilist); memory->destroy(numneigh); memory->sfree(firstneigh); @@ -144,6 +146,7 @@ void NeighList::post_constructor(NeighRequest *nq) respamiddle = nq->respamiddle; respainner = nq->respainner; copy = nq->copy; + trim = nq->trim; id = nq->id; if (nq->copy) { diff --git a/src/neigh_list.h b/src/neigh_list.h index abd9b8205e..9b1bc238e6 100644 --- a/src/neigh_list.h +++ b/src/neigh_list.h @@ -42,6 +42,7 @@ class NeighList : protected Pointers { int respamiddle; // 1 if there is also a rRespa middle list int respainner; // 1 if there is also a rRespa inner list int copy; // 1 if this list is copied from another list + int trim; // 1 if this list is trimmed from another list int kk2cpu; // 1 if this list is copied from Kokkos to CPU int copymode; // 1 if this is a Kokkos on-device copy int id; // copied from neighbor list request diff --git a/src/neigh_request.cpp b/src/neigh_request.cpp index f859ca0fd4..37da50eaea 100644 --- a/src/neigh_request.cpp +++ b/src/neigh_request.cpp @@ -86,6 +86,7 @@ NeighRequest::NeighRequest(LAMMPS *_lmp) : Pointers(_lmp) skiplist = -1; off2on = 0; copy = 0; + trim = 0; copylist = -1; halffull = 0; halffulllist = -1; diff --git a/src/neigh_request.h b/src/neigh_request.h index 71c5987dbe..9dfc03f7f0 100644 --- a/src/neigh_request.h +++ b/src/neigh_request.h @@ -102,6 +102,7 @@ class NeighRequest : protected Pointers { int off2on; // 1 if this is newton on list, but skips from off list int copy; // 1 if this list copied from another list + int trim; // 1 if this list copied from another list and then trimmed int copylist; // index of list to copy from int halffull; // 1 if half list computed from another full list diff --git a/src/neighbor.cpp b/src/neighbor.cpp index 560392ae6d..d5b4915f82 100644 --- a/src/neighbor.cpp +++ b/src/neighbor.cpp @@ -162,6 +162,7 @@ pairclass(nullptr), pairnames(nullptr), pairmasks(nullptr) nrequest = maxrequest = 0; requests = nullptr; + j_sorted = nullptr; old_nrequest = 0; old_requests = nullptr; @@ -254,6 +255,8 @@ Neighbor::~Neighbor() if (old_requests[i]) delete old_requests[i]; memory->sfree(old_requests); + delete[] j_sorted; + delete[] binclass; delete[] binnames; delete[] binmasks; @@ -827,6 +830,10 @@ int Neighbor::init_pair() "with ghost info"); } + // sort requests by cutoff distance for trimming + + sort_requests(); + // morph requests in various ways // purpose is to avoid duplicate or inefficient builds // may add new requests if a needed request to derive from does not exist @@ -840,7 +847,7 @@ int Neighbor::init_pair() // (3) after (2), b/c it adjusts lists created by (2) // (4) after (2) and (3), // b/c (2) may create new full lists, (3) may change them - // (5) last, after all lists are finalized, so all possible copies found + // (5) last, after all lists are finalized, so all possible copies/trims found int nrequest_original = nrequest; @@ -848,7 +855,7 @@ int Neighbor::init_pair() morph_skip(); morph_granular(); // this method can change flags set by requestor morph_halffull(); - morph_copy(); + morph_copy_trim(); // create new lists, one per request including added requests // wait to allocate initial pages until copy lists are detected @@ -1007,8 +1014,8 @@ int Neighbor::init_pair() // allocate initial pages for each list, except if copy flag set for (i = 0; i < nlist; i++) { - if (lists[i]->copy && !lists[i]->kk2cpu) - continue; + if (lists[i]->copy && !lists[i]->trim && !lists[i]->kk2cpu) + continue; lists[i]->setup_pages(pgsize,oneatom); } @@ -1020,7 +1027,7 @@ int Neighbor::init_pair() int maxatom = atom->nmax; for (i = 0; i < nlist; i++) { - if (neigh_pair[i] && (!lists[i]->copy || lists[i]->kk2cpu)) + if (neigh_pair[i] && (!lists[i]->copy || lists[i]->trim || lists[i]->kk2cpu)) lists[i]->grow(maxatom,maxatom); } @@ -1092,6 +1099,42 @@ int Neighbor::init_pair() return same; } +/* ---------------------------------------------------------------------- + sort NeighRequests by cutoff distance + to find smallest list for trimming +------------------------------------------------------------------------- */ + +void Neighbor::sort_requests() +{ + NeighRequest *jrq; + int i,j,jmin; + double jcut; + + delete[] j_sorted; + j_sorted = new int[nrequest]; + + for (i = 0; i < nrequest; i++) + j_sorted[i] = i; + + for (i = 0; i < nrequest; i++) { + double cutoff_min = cutneighmax; + + for (j = i; j < nrequest; j++) { + jrq = requests[j_sorted[j]]; + if (jrq->cut) jcut = jrq->cutoff; + else jcut = cutneighmax; + + if (jcut <= cutoff_min) { + cutoff_min = jcut; + jmin = j; + } + } + int tmp = j_sorted[i]; + j_sorted[i] = jmin; + j_sorted[jmin] = tmp; + } +} + /* ---------------------------------------------------------------------- scan NeighRequests to set additional flags: custom cutoff lists and accelerator lists @@ -1104,10 +1147,23 @@ void Neighbor::morph_unique() for (int i = 0; i < nrequest; i++) { irq = requests[i]; - // if cut flag set by requestor, set unique flag + // if cut flag set by requestor and cutoff is different than default, + // set unique flag, otherwise unset cut flag // this forces Pair,Stencil,Bin styles to be instantiated separately + // also add skin to cutoff of perpetual lists - if (irq->cut) irq->unique = 1; + if (irq->cut) { + if (!irq->occasional) + irq->cutoff += skin; + + if (irq->cutoff != cutneighmax) { + irq->unique = 1; + + } else { + irq->cut = 0; + irq->cutoff = 0.0; + } + } // avoid flagging a neighbor list as both INTEL and OPENMP @@ -1292,8 +1348,9 @@ void Neighbor::morph_granular() void Neighbor::morph_halffull() { - int i,j; + int i,j,jj,jmin; NeighRequest *irq,*jrq; + double icut,jcut; for (i = 0; i < nrequest; i++) { irq = requests[i]; @@ -1309,8 +1366,10 @@ void Neighbor::morph_halffull() // check all other lists - for (j = 0; j < nrequest; j++) { - if (i == j) continue; + for (jj = 0; jj < nrequest; jj++) { + if (irq->cut) j = j_sorted[jj]; + else j = jj; + jrq = requests[j]; // can only derive from a perpetual full list @@ -1319,10 +1378,20 @@ void Neighbor::morph_halffull() if (jrq->occasional) continue; if (!jrq->full) continue; + // trim a list with longer cutoff + + if (irq->cut) icut = irq->cutoff; + else icut = cutneighmax; + + if (jrq->cut) jcut = jrq->cutoff; + else jcut = cutneighmax; + + if (icut > jcut) continue; + else if (icut != jcut) irq->trim = 1; + // these flags must be same, // else 2 lists do not store same pairs // or their data structures are different - // this includes custom cutoff set by requestor if (irq->ghost != jrq->ghost) continue; if (irq->size != jrq->size) continue; @@ -1333,8 +1402,6 @@ void Neighbor::morph_halffull() if (irq->kokkos_host != jrq->kokkos_host) continue; if (irq->kokkos_device != jrq->kokkos_device) continue; if (irq->ssa != jrq->ssa) continue; - if (irq->cut != jrq->cut) continue; - if (irq->cutoff != jrq->cutoff) continue; // skip flag must be same // if both are skip lists, skip info must match @@ -1349,22 +1416,23 @@ void Neighbor::morph_halffull() // if matching list exists, point to it - if (j < nrequest) { + if (jj < nrequest) { irq->halffull = 1; irq->halffulllist = j; - } + } else irq->trim = 0; } } /* ---------------------------------------------------------------------- - scan NeighRequests for possible copies - if 2 requests match, turn one into a copy of the other + scan NeighRequests for possible copies or trims + if 2 requests match, turn one into a copy or trim of the other ------------------------------------------------------------------------- */ -void Neighbor::morph_copy() +void Neighbor::morph_copy_trim() { - int i,j,inewton,jnewton; + int i,j,jj,jmin,inewton,jnewton; NeighRequest *irq,*jrq; + double icut,jcut; for (i = 0; i < nrequest; i++) { irq = requests[i]; @@ -1375,7 +1443,10 @@ void Neighbor::morph_copy() // check all other lists - for (j = 0; j < nrequest; j++) { + for (jj = 0; jj < nrequest; jj++) { + if (irq->cut) j = j_sorted[jj]; + else j = jj; + if (i == j) continue; jrq = requests[j]; @@ -1383,13 +1454,24 @@ void Neighbor::morph_copy() if (jrq->copy && jrq->copylist == i) continue; + // trim a list with longer cutoff + + if (irq->cut) icut = irq->cutoff; + else icut = cutneighmax; + + if (jrq->cut) jcut = jrq->cutoff; + else jcut = cutneighmax; + + if (icut > jcut) continue; + else if (icut != jcut) irq->trim = 1; + // other list (jrq) to copy from must be perpetual // list that becomes a copy list (irq) can be perpetual or occasional // if both lists are perpetual, require j < i // to prevent circular dependence with 3 or more copies of a list if (jrq->occasional) continue; - if (!irq->occasional && j > i) continue; + if (!irq->occasional && !irq->cut && j > i) continue; // both lists must be half, or both full @@ -1418,7 +1500,6 @@ void Neighbor::morph_copy() // these flags must be same, // else 2 lists do not store same pairs // or their data structures are different - // this includes custom cutoff set by requestor // no need to check omp b/c it stores same pairs // NOTE: need check for 2 Kokkos flags? @@ -1429,8 +1510,6 @@ void Neighbor::morph_copy() if (irq->kokkos_host && !jrq->kokkos_host) continue; if (irq->kokkos_device && !jrq->kokkos_device) continue; if (irq->ssa != jrq->ssa) continue; - if (irq->cut != jrq->cut) continue; - if (irq->cutoff != jrq->cutoff) continue; // skip flag must be same // if both are skip lists, skip info must match @@ -1446,11 +1525,11 @@ void Neighbor::morph_copy() // turn list I into a copy of list J // do not copy a list from another copy list, but from its parent list - if (j < nrequest) { + if (jj < nrequest) { irq->copy = 1; if (jrq->copy) irq->copylist = jrq->copylist; else irq->copylist = j; - } + } else irq->trim = 0; } } @@ -1664,9 +1743,12 @@ void Neighbor::print_pairwise_info() // order these to get single output of most relevant - if (rq->copy) - out += fmt::format(", copy from ({})",rq->copylist+1); - else if (rq->halffull) + if (rq->copy) { + if (rq->trim) + out += fmt::format(", trim from ({})",rq->copylist+1); + else + out += fmt::format(", copy from ({})",rq->copylist+1); + } else if (rq->halffull) out += fmt::format(", half/full from ({})",rq->halffulllist+1); else if (rq->skip) out += fmt::format(", skip from ({})",rq->skiplist+1); @@ -1968,10 +2050,12 @@ int Neighbor::choose_pair(NeighRequest *rq) // pairnames[i],pairmasks[i]); // if copy request, no further checks needed, just return or continue - // Kokkos device/host flags must also match in order to copy + // Trim and Kokkos device/host flags must also match in order to copy if (rq->copy) { if (!(mask & NP_COPY)) continue; + if (rq->trim) + if (!rq->trim != !(mask & NP_TRIM)) continue; if (rq->kokkos_device || rq->kokkos_host) { if (!rq->kokkos_device != !(mask & NP_KOKKOS_DEVICE)) continue; if (!rq->kokkos_host != !(mask & NP_KOKKOS_HOST)) continue; @@ -2023,6 +2107,8 @@ int Neighbor::choose_pair(NeighRequest *rq) if (!rq->skip != !(mask & NP_SKIP)) continue; + if (!rq->trim != !(mask & NP_TRIM)) continue; + if (!rq->halffull != !(mask & NP_HALF_FULL)) continue; if (!rq->off2on != !(mask & NP_OFF2ON)) continue; @@ -2327,7 +2413,7 @@ void Neighbor::build(int topoflag) for (i = 0; i < npair_perpetual; i++) { m = plist[i]; - if (!lists[m]->copy || lists[m]->kk2cpu) + if (!lists[m]->copy || lists[m]->trim || lists[m]->kk2cpu) lists[m]->grow(nlocal,nall); neigh_pair[m]->build_setup(); neigh_pair[m]->build(lists[m]); @@ -2418,7 +2504,7 @@ void Neighbor::build_one(class NeighList *mylist, int preflag) // build the list - if (!mylist->copy || mylist->kk2cpu) + if (!mylist->copy || mylist->trim || mylist->kk2cpu) mylist->grow(atom->nlocal,atom->nlocal+atom->nghost); np->build_setup(); np->build(mylist); diff --git a/src/neighbor.h b/src/neighbor.h index 3492693766..7d1711c149 100644 --- a/src/neighbor.h +++ b/src/neighbor.h @@ -94,6 +94,7 @@ class Neighbor : protected Pointers { NeighList **lists; NeighRequest **requests; // from Pair,Fix,Compute,Command classes NeighRequest **old_requests; // copy of requests to compare to + int* j_sorted; // index of requests sorted by cutoff distance // data from topology neighbor lists @@ -245,11 +246,13 @@ class Neighbor : protected Pointers { int init_pair(); virtual void init_topology(); + void sort_requests(); + void morph_unique(); void morph_skip(); void morph_granular(); void morph_halffull(); - void morph_copy(); + void morph_copy_trim(); void print_pairwise_info(); void requests_new2old(); @@ -323,7 +326,8 @@ namespace NeighConst { NP_SKIP = 1 << 22, NP_HALF_FULL = 1 << 23, NP_OFF2ON = 1 << 24, - NP_MULTI_OLD = 1 << 25 + NP_MULTI_OLD = 1 << 25, + NP_TRIM = 1 << 26 }; enum { diff --git a/src/npair_halffull_newtoff_trim.cpp b/src/npair_halffull_newtoff_trim.cpp new file mode 100644 index 0000000000..28b285ddf3 --- /dev/null +++ b/src/npair_halffull_newtoff_trim.cpp @@ -0,0 +1,101 @@ +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + https://www.lammps.org/, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#include "npair_halffull_newtoff_trim.h" + +#include "atom.h" +#include "error.h" +#include "my_page.h" +#include "neigh_list.h" + +using namespace LAMMPS_NS; + +/* ---------------------------------------------------------------------- */ + +NPairHalffullNewtoffTrim::NPairHalffullNewtoffTrim(LAMMPS *lmp) : NPair(lmp) {} + +/* ---------------------------------------------------------------------- + build half list from full list + pair stored once if i,j are both owned and i < j + pair stored by me if j is ghost (also stored by proc owning j) + works if full list is a skip list + works for owned (non-ghost) list, also for ghost list + if ghost, also store neighbors of ghost atoms & set inum,gnum correctly +------------------------------------------------------------------------- */ + +void NPairHalffullNewtoffTrim::build(NeighList *list) +{ + int i, j, ii, jj, n, jnum, joriginal; + int *neighptr, *jlist; + double xtmp,ytmp,ztmp; + double delx,dely,delz,rsq; + + double **x = atom->x; + + int *ilist = list->ilist; + int *numneigh = list->numneigh; + int **firstneigh = list->firstneigh; + MyPage *ipage = list->ipage; + + int *ilist_full = list->listfull->ilist; + int *numneigh_full = list->listfull->numneigh; + int **firstneigh_full = list->listfull->firstneigh; + int inum_full = list->listfull->inum; + if (list->ghost) inum_full += list->listfull->gnum; + + int inum = 0; + ipage->reset(); + + double cutsq_custom = cutoff_custom * cutoff_custom; + + // loop over atoms in full list + + for (ii = 0; ii < inum_full; ii++) { + n = 0; + neighptr = ipage->vget(); + + // loop over parent full list + + i = ilist_full[ii]; + xtmp = x[i][0]; + ytmp = x[i][1]; + ztmp = x[i][2]; + + jlist = firstneigh_full[i]; + jnum = numneigh_full[i]; + + for (jj = 0; jj < jnum; jj++) { + joriginal = jlist[jj]; + j = joriginal & NEIGHMASK; + if (j > i) { + delx = xtmp - x[j][0]; + dely = ytmp - x[j][1]; + delz = ztmp - x[j][2]; + rsq = delx * delx + dely * dely + delz * delz; + + if (rsq > cutsq_custom) continue; + + neighptr[n++] = joriginal; + } + } + + ilist[inum++] = i; + firstneigh[i] = neighptr; + numneigh[i] = n; + ipage->vgot(n); + if (ipage->status()) error->one(FLERR, "Neighbor list overflow, boost neigh_modify one"); + } + + list->inum = inum; + if (list->ghost) list->gnum = list->listfull->gnum; +} diff --git a/src/npair_halffull_newtoff_trim.h b/src/npair_halffull_newtoff_trim.h new file mode 100644 index 0000000000..a5e39e4800 --- /dev/null +++ b/src/npair_halffull_newtoff_trim.h @@ -0,0 +1,54 @@ +/* -*- c++ -*- ---------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + https://www.lammps.org/, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#ifdef NPAIR_CLASS +// clang-format off +NPairStyle(halffull/newtoff/trim, + NPairHalffullNewtoffTrim, + NP_HALF_FULL | NP_NEWTOFF | NP_NSQ | NP_BIN | NP_MULTI | NP_MULTI_OLD | NP_HALF | + NP_ORTHO | NP_TRI | NP_TRIM); + +NPairStyle(halffull/newtoff/skip/trim, + NPairHalffullNewtoffTrim, + NP_HALF_FULL | NP_NEWTOFF | NP_NSQ | NP_BIN | NP_MULTI | NP_MULTI_OLD | NP_HALF | + NP_ORTHO | NP_TRI | NP_SKIP | NP_TRIM); + +NPairStyle(halffull/newtoff/ghost/trim, + NPairHalffullNewtoffTrim, + NP_HALF_FULL | NP_NEWTOFF | NP_NSQ | NP_BIN | NP_MULTI | NP_MULTI_OLD | NP_HALF | + NP_ORTHO | NP_TRI | NP_GHOST | NP_TRIM); + +NPairStyle(halffull/newtoff/skip/ghost/trim, + NPairHalffullNewtoffTrim, + NP_HALF_FULL | NP_NEWTOFF | NP_NSQ | NP_BIN | NP_MULTI | NP_MULTI_OLD | NP_HALF | + NP_ORTHO | NP_TRI | NP_SKIP | NP_GHOST | NP_TRIM); +// clang-format on +#else + +#ifndef LMP_NPAIR_HALFFULL_NEWTOFF_TRIM_H +#define LMP_NPAIR_HALFFULL_NEWTOFF_TRIM_H + +#include "npair.h" + +namespace LAMMPS_NS { + +class NPairHalffullNewtoffTrim : public NPair { + public: + NPairHalffullNewtoffTrim(class LAMMPS *); + void build(class NeighList *) override; +}; + +} // namespace LAMMPS_NS + +#endif +#endif diff --git a/src/npair_halffull_newton_trim.cpp b/src/npair_halffull_newton_trim.cpp new file mode 100644 index 0000000000..89a28e81ae --- /dev/null +++ b/src/npair_halffull_newton_trim.cpp @@ -0,0 +1,108 @@ +// clang-format off +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + https://www.lammps.org/, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#include "npair_halffull_newton_trim.h" + +#include "atom.h" +#include "error.h" +#include "my_page.h" +#include "neigh_list.h" + +using namespace LAMMPS_NS; + +/* ---------------------------------------------------------------------- */ + +NPairHalffullNewtonTrim::NPairHalffullNewtonTrim(LAMMPS *lmp) : NPair(lmp) {} + +/* ---------------------------------------------------------------------- + build half list from full list + pair stored once if i,j are both owned and i < j + if j is ghost, only store if j coords are "above and to the right" of i + works if full list is a skip list +------------------------------------------------------------------------- */ + +void NPairHalffullNewtonTrim::build(NeighList *list) +{ + int i,j,ii,jj,n,jnum,joriginal; + int *neighptr,*jlist; + double xtmp,ytmp,ztmp; + double delx,dely,delz,rsq; + + double **x = atom->x; + int nlocal = atom->nlocal; + + int *ilist = list->ilist; + int *numneigh = list->numneigh; + int **firstneigh = list->firstneigh; + MyPage *ipage = list->ipage; + + int *ilist_full = list->listfull->ilist; + int *numneigh_full = list->listfull->numneigh; + int **firstneigh_full = list->listfull->firstneigh; + int inum_full = list->listfull->inum; + + int inum = 0; + ipage->reset(); + + double cutsq_custom = cutoff_custom * cutoff_custom; + + // loop over parent full list + + for (ii = 0; ii < inum_full; ii++) { + n = 0; + neighptr = ipage->vget(); + + i = ilist_full[ii]; + xtmp = x[i][0]; + ytmp = x[i][1]; + ztmp = x[i][2]; + + // loop over full neighbor list + + jlist = firstneigh_full[i]; + jnum = numneigh_full[i]; + + for (jj = 0; jj < jnum; jj++) { + joriginal = jlist[jj]; + j = joriginal & NEIGHMASK; + if (j < nlocal) { + if (i > j) continue; + } else { + if (x[j][2] < ztmp) continue; + if (x[j][2] == ztmp) { + if (x[j][1] < ytmp) continue; + if (x[j][1] == ytmp && x[j][0] < xtmp) continue; + } + } + + delx = xtmp - x[j][0]; + dely = ytmp - x[j][1]; + delz = ztmp - x[j][2]; + rsq = delx * delx + dely * dely + delz * delz; + + if (rsq > cutsq_custom) continue; + + neighptr[n++] = joriginal; + } + + ilist[inum++] = i; + firstneigh[i] = neighptr; + numneigh[i] = n; + ipage->vgot(n); + if (ipage->status()) + error->one(FLERR,"Neighbor list overflow, boost neigh_modify one"); + } + + list->inum = inum; +} diff --git a/src/npair_halffull_newton_trim.h b/src/npair_halffull_newton_trim.h new file mode 100644 index 0000000000..344ed618a8 --- /dev/null +++ b/src/npair_halffull_newton_trim.h @@ -0,0 +1,44 @@ +/* -*- c++ -*- ---------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + https://www.lammps.org/, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#ifdef NPAIR_CLASS +// clang-format off +NPairStyle(halffull/newton/trim, + NPairHalffullNewtonTrim, + NP_HALF_FULL | NP_NEWTON | NP_HALF | NP_NSQ | NP_BIN | NP_MULTI | NP_MULTI_OLD | + NP_ORTHO | NP_TRI | NP_TRIM); + +NPairStyle(halffull/newton/skip/trim, + NPairHalffullNewtonTrim, + NP_HALF_FULL | NP_NEWTON | NP_HALF | NP_NSQ | NP_BIN | NP_MULTI | NP_MULTI_OLD | + NP_ORTHO | NP_TRI | NP_SKIP | NP_TRIM); +// clang-format on +#else + +#ifndef LMP_NPAIR_HALFFULL_NEWTON_TRIM_H +#define LMP_NPAIR_HALFFULL_NEWTON_TRIM_H + +#include "npair.h" + +namespace LAMMPS_NS { + +class NPairHalffullNewtonTrim : public NPair { + public: + NPairHalffullNewtonTrim(class LAMMPS *); + void build(class NeighList *) override; +}; + +} // namespace LAMMPS_NS + +#endif +#endif diff --git a/src/npair_trim.cpp b/src/npair_trim.cpp new file mode 100644 index 0000000000..5d854b745e --- /dev/null +++ b/src/npair_trim.cpp @@ -0,0 +1,92 @@ +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + https://www.lammps.org/, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Trimright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#include "npair_trim.h" +#include "neigh_list.h" +#include "atom.h" +#include "error.h" +#include "my_page.h" + +using namespace LAMMPS_NS; + +/* ---------------------------------------------------------------------- */ + +NPairTrim::NPairTrim(LAMMPS *lmp) : NPair(lmp) {} + +/* ---------------------------------------------------------------------- + create list which is a trimmed version of parent list +------------------------------------------------------------------------- */ + +void NPairTrim::build(NeighList *list) +{ + NeighList *listcopy = list->listcopy; + + double cutsq_custom = cutoff_custom * cutoff_custom; + + int i,j,ii,jj,n,jnum,joriginal; + int *neighptr,*jlist; + double xtmp,ytmp,ztmp; + double delx,dely,delz,rsq; + + double **x = atom->x; + + int *ilist = list->ilist; + int *numneigh = list->numneigh; + int **firstneigh = list->firstneigh; + MyPage *ipage = list->ipage; + ipage->reset(); + + int *ilist_copy = listcopy->ilist; + int *numneigh_copy = listcopy->numneigh; + int **firstneigh_copy = listcopy->firstneigh; + int inum = listcopy->inum; + + list->inum = inum; + list->gnum = listcopy->gnum; + + for (ii = 0; ii < inum; ii++) { + n = 0; + neighptr = ipage->vget(); + + const int i = ilist_copy[ii]; + ilist[i] = i; + xtmp = x[i][0]; + ytmp = x[i][1]; + ztmp = x[i][2]; + + // loop over copy list with larger cutoff and trim to shorter cutoff + + jlist = firstneigh_copy[i]; + jnum = numneigh_copy[i]; + + for (jj = 0; jj < jnum; jj++) { + joriginal = jlist[jj]; + j = joriginal & NEIGHMASK; + + delx = xtmp - x[j][0]; + dely = ytmp - x[j][1]; + delz = ztmp - x[j][2]; + rsq = delx * delx + dely * dely + delz * delz; + + if (rsq > cutsq_custom) continue; + + neighptr[n++] = joriginal; + } + + firstneigh[i] = neighptr; + numneigh[i] = n; + ipage->vgot(n); + if (ipage->status()) + error->one(FLERR,"Neighbor list overflow, boost neigh_modify one"); + } +} diff --git a/src/npair_trim.h b/src/npair_trim.h new file mode 100644 index 0000000000..d8510051c8 --- /dev/null +++ b/src/npair_trim.h @@ -0,0 +1,38 @@ +/* -*- c++ -*- ---------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + https://www.lammps.org/, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Trimright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#ifdef NPAIR_CLASS +// clang-format off +NPairStyle(trim, + NPairTrim, + NP_COPY | NP_TRIM); +// clang-format on +#else + +#ifndef LMP_NPAIR_TRIM_H +#define LMP_NPAIR_TRIM_H + +#include "npair.h" + +namespace LAMMPS_NS { + +class NPairTrim : public NPair { + public: + NPairTrim(class LAMMPS *); + void build(class NeighList *) override; +}; + +} // namespace LAMMPS_NS + +#endif +#endif diff --git a/src/pair.cpp b/src/pair.cpp index 5ce4dc2d32..d41e7b706c 100644 --- a/src/pair.cpp +++ b/src/pair.cpp @@ -204,6 +204,10 @@ void Pair::modify_params(int narg, char **arg) } else if (strcmp(arg[iarg],"nofdotr") == 0) { no_virial_fdotr_compute = 1; ++iarg; + } else if (strcmp(arg[iarg],"neigh/trim") == 0) { + if (iarg+2 > narg) error->all(FLERR,"Illegal pair_modify command"); + trim_flag = utils::logical(FLERR,arg[iarg+1],false,lmp); + iarg += 2; } else error->all(FLERR,"Illegal pair_modify command"); } } diff --git a/src/pair.h b/src/pair.h index 5bad9e14a3..4a997addb6 100644 --- a/src/pair.h +++ b/src/pair.h @@ -82,6 +82,7 @@ class Pair : protected Pointers { int tail_flag; // pair_modify flag for LJ tail correction double etail, ptail; // energy/pressure tail corrections double etail_ij, ptail_ij; + int trim_flag; // pair_modify flag for trimming neigh list int evflag; // energy,virial settings int eflag_either, eflag_global, eflag_atom; diff --git a/src/pair_hybrid.cpp b/src/pair_hybrid.cpp index f4043bcdf9..3af497ca15 100644 --- a/src/pair_hybrid.cpp +++ b/src/pair_hybrid.cpp @@ -35,12 +35,13 @@ using namespace LAMMPS_NS; PairHybrid::PairHybrid(LAMMPS *lmp) : Pair(lmp), styles(nullptr), keywords(nullptr), multiple(nullptr), nmap(nullptr), - map(nullptr), special_lj(nullptr), special_coul(nullptr), compute_tally(nullptr) + map(nullptr), special_lj(nullptr), special_coul(nullptr), compute_tally(nullptr), cutmax_style(nullptr) { nstyles = 0; outerflag = 0; respaflag = 0; + style_cutoff_flag = 1; } /* ---------------------------------------------------------------------- */ @@ -56,6 +57,8 @@ PairHybrid::~PairHybrid() } } delete[] styles; + if (style_cutoff_flag) + delete[] cutmax_style; delete[] keywords; delete[] multiple; @@ -298,6 +301,10 @@ void PairHybrid::settings(int narg, char **arg) // allocate list of sub-styles as big as possibly needed if no extra args styles = new Pair *[narg]; + if (style_cutoff_flag) { + cutmax_style = new double[narg]; + memset(cutmax_style, 0.0, narg*sizeof(double)); + } keywords = new char *[narg]; multiple = new int[narg]; @@ -716,6 +723,23 @@ double PairHybrid::init_one(int i, int j) ptail_ij += styles[map[i][j][k]]->ptail_ij; } cutmax = MAX(cutmax,cut); + + if (style_cutoff_flag) { + int istyle; + for (istyle = 0; istyle < nstyles; istyle++) + if (styles[istyle] == styles[map[i][j][k]]) break; + + if (cut > cutmax_style[istyle]) { + cutmax_style[istyle] = cut; + + for (auto &request : neighbor->get_pair_requests()) { + if (styles[istyle] == request->get_requestor() && styles[istyle]->trim_flag) { + request->set_cutoff(cutmax_style[istyle]); + break; + } + } + } + } } return cutmax; @@ -778,6 +802,10 @@ void PairHybrid::read_restart(FILE *fp) delete[] compute_tally; styles = new Pair*[nstyles]; + if (style_cutoff_flag) { + cutmax_style = new double[nstyles]; + memset(cutmax_style, 0.0, nstyles*sizeof(double)); + } keywords = new char*[nstyles]; multiple = new int[nstyles]; diff --git a/src/pair_hybrid.h b/src/pair_hybrid.h index 84056f1e79..97bb01d8e7 100644 --- a/src/pair_hybrid.h +++ b/src/pair_hybrid.h @@ -68,10 +68,12 @@ class PairHybrid : public Pair { double radii2cut(double, double) override; protected: - int nstyles; // # of sub-styles - Pair **styles; // list of Pair style classes - char **keywords; // style name of each Pair style - int *multiple; // 0 if style used once, else Mth instance + int nstyles; // # of sub-styles + Pair **styles; // list of Pair style classes + int style_cutoff_flag; // 1 if build a separate neigh list for each style + double *cutmax_style; // max cutoff for each style + char **keywords; // style name of each Pair style + int *multiple; // 0 if style used once, else Mth instance int outerflag; // toggle compute() when invoked by outer() int respaflag; // 1 if different substyles are assigned to From fcb60588116499e5e89249f25088a85e5cdb7943 Mon Sep 17 00:00:00 2001 From: rohskopf Date: Thu, 7 Jul 2022 16:51:11 -0600 Subject: [PATCH 549/585] More formatting --- src/ML-SNAP/compute_snap.cpp | 21 ++++++++++----------- 1 file changed, 10 insertions(+), 11 deletions(-) diff --git a/src/ML-SNAP/compute_snap.cpp b/src/ML-SNAP/compute_snap.cpp index 515af28360..3200ecd756 100644 --- a/src/ML-SNAP/compute_snap.cpp +++ b/src/ML-SNAP/compute_snap.cpp @@ -522,21 +522,21 @@ void ComputeSnap::compute_array() for (int icoeff = 0; icoeff < ncoeff; icoeff++) { - // add to snap array for this proc + // add to snap array for this proc - // dBi/dRj + // dBi/dRj - snap[bik_rows + ((atom->tag[j]-1)*3*natoms) + 3*(atom->tag[i]-1) + 0][icoeff+3] -= snaptr->dblist[icoeff][0]; - snap[bik_rows + ((atom->tag[j]-1)*3*natoms) + 3*(atom->tag[i]-1) + 1][icoeff+3] -= snaptr->dblist[icoeff][1]; - snap[bik_rows + ((atom->tag[j]-1)*3*natoms) + 3*(atom->tag[i]-1) + 2][icoeff+3] -= snaptr->dblist[icoeff][2]; + snap[bik_rows + ((atom->tag[j]-1)*3*natoms) + 3*(atom->tag[i]-1) + 0][icoeff+3] -= snaptr->dblist[icoeff][0]; + snap[bik_rows + ((atom->tag[j]-1)*3*natoms) + 3*(atom->tag[i]-1) + 1][icoeff+3] -= snaptr->dblist[icoeff][1]; + snap[bik_rows + ((atom->tag[j]-1)*3*natoms) + 3*(atom->tag[i]-1) + 2][icoeff+3] -= snaptr->dblist[icoeff][2]; - // dBi/dRi + // dBi/dRi - snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 0][icoeff+3] += snaptr->dblist[icoeff][0]; - snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 1][icoeff+3] += snaptr->dblist[icoeff][1]; - snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 2][icoeff+3] += snaptr->dblist[icoeff][2]; + snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 0][icoeff+3] += snaptr->dblist[icoeff][0]; + snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 1][icoeff+3] += snaptr->dblist[icoeff][1]; + snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 2][icoeff+3] += snaptr->dblist[icoeff][2]; + } } - } } // loop over jj inside @@ -592,7 +592,6 @@ void ComputeSnap::compute_array() } } } - } // accumulate forces to global array From ae615eb81552b3a342b69b572d93cd840beb736f Mon Sep 17 00:00:00 2001 From: rohskopf Date: Thu, 7 Jul 2022 16:53:20 -0600 Subject: [PATCH 550/585] More whitespace in docs --- doc/src/compute_sna_atom.rst | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/doc/src/compute_sna_atom.rst b/doc/src/compute_sna_atom.rst index f4d2983997..5efecd6738 100644 --- a/doc/src/compute_sna_atom.rst +++ b/doc/src/compute_sna_atom.rst @@ -77,7 +77,7 @@ Syntax *dinnerlist* = *ntypes* values of *Dinner* (distance units) *bikflag* value = *0* or *1* (only implemented for compute snap) *0* = descriptors are summed over atoms of each type - *1* = descriptors are listed separately for each atom + *1* = descriptors are listed separately for each atom *dgradflag* value = *0* or *1* (only implemented for compute snap) *0* = descriptor gradients are summed over atoms of each type *1* = descriptor gradients are listed separately for each atom pair From 5bca3fd0b013955c05f871ec9f1259267b6fbf57 Mon Sep 17 00:00:00 2001 From: rohskopf Date: Thu, 7 Jul 2022 17:00:52 -0600 Subject: [PATCH 551/585] Remove an output file --- examples/mliap/Ta06A.mliap.pytorch.model.pt | Bin 2087 -> 0 bytes 1 file changed, 0 insertions(+), 0 deletions(-) delete mode 100644 examples/mliap/Ta06A.mliap.pytorch.model.pt diff --git a/examples/mliap/Ta06A.mliap.pytorch.model.pt b/examples/mliap/Ta06A.mliap.pytorch.model.pt deleted file mode 100644 index fc2e10398ec6fae4978e37c11ac899615096ef7d..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 2087 zcmah~YfKzf6rSbHP~Nmf(8a2ihhK`>yjTIC9p(ZBYJ2SAmAoeDAZtgwj zeD~b%JjTZ)CQ(#c8nt5NPFXofsRB7nV~YujtjHX`O%pX8$@-!Wry(8E z103Fqk}k>|N8=M3=qDj#1lIT=lg%d9y?kKcAg=~FK~V-Y$TE?$*>yxFYFuALlHzqB zr<2Vh(mq9vG0Zg$^VqytQCLMbZoVllU~`FB(|H|nLHs&fy4IAgV~dDXQutu3N)%+h zsa9xl5mJH?32AVbd050IV_STNBq;vx(6slN2~i?g zwB9SE3z(%1BXFM|?iVaZ9uRUm1?!C)1?w>n3YOcYg5_74V7XGxreIgJNUw||P!TZm z!X?Wt+hLa^%7|C#UDg5*VNW&v zhoKk;<2(lSjFWL3gNKisoHgjs=!dOi=H`)6*ye{O78e%PEAkq6glYlbE7S-UtQ)oq zb&NxY9VXlecp1kCG+R(DI<)$s&4SuF3Xl4sJz|ICF)Jj@2<-AhhaHm6Xh?S3A@SKE z*<**qZ-->BS#P)q`Vg;2RGc;Y7$>_1`>90q=wTP*i1gyXX(s(aG$;lTJl<)hR!~12 zM$m1u)`yc+-%?8hYbGNuKvK#YJi(N(nHW~)f=COfVi@zP!G3%hZJr{WeYi+9=pk3R zd`xOuf@8-!ZJ07LeXDk*EUGE4D^*puc^jAYq__rkhfV8n)61ppqXye>`R3pUM~s^b zp}#McOdGZDAN}$*@2oMWGG{ixjHkQjJ>!>&vz{N%Z~Wot#5vDJmweiB?YhxCUpILC z=Q-ob*usso>#rKOI$A59ublKqP3JS$et*q)#yy^YyJFJg_8z(nH!d1{z0@=Q)dhn; z;WTD`nlVb>dgE)R=&Ipr_;oz%i&cEMM0 zD}UM;Zl3aAN`2P|O%={7-Zu>?>AT23&%I!r?4B=t>G}zyHS=x$&#^;Bam7b}o$_5U zl25;4`F(0=f|_Z;V_W-e@qv|Gwp8k=B!|vIqCoOHcI`F;J$d| z=_{nales!>HnnvLcaXGeMQ-!fuK>P7+!n=~X>#*t6a8HY_*OD~jDsvo|Fqb=${~Wd zvHTCW+&Y#k((R+;Rh*}>)>YNZZDaX}x214rjI(tww~c)f`9DPmsmVoKn?E0ulCsIx ta3)qR>5>LS#^U Date: Thu, 7 Jul 2022 17:04:20 -0600 Subject: [PATCH 552/585] Remove symbolic link directory --- python/lammps/__init__.py | 49 - python/lammps/constants.py | 48 - python/lammps/core.py | 2097 ------------------------------- python/lammps/data.py | 92 -- python/lammps/formats.py | 227 ---- python/lammps/mliap/__init__.py | 20 - python/lammps/mliap/loader.py | 52 - python/lammps/mliap/pytorch.py | 326 ----- python/lammps/numpy_wrapper.py | 483 ------- python/lammps/pylammps.py | 990 --------------- 10 files changed, 4384 deletions(-) delete mode 100644 python/lammps/__init__.py delete mode 100644 python/lammps/constants.py delete mode 100644 python/lammps/core.py delete mode 100644 python/lammps/data.py delete mode 100644 python/lammps/formats.py delete mode 100644 python/lammps/mliap/__init__.py delete mode 100644 python/lammps/mliap/loader.py delete mode 100644 python/lammps/mliap/pytorch.py delete mode 100644 python/lammps/numpy_wrapper.py delete mode 100644 python/lammps/pylammps.py diff --git a/python/lammps/__init__.py b/python/lammps/__init__.py deleted file mode 100644 index fc35e45225..0000000000 --- a/python/lammps/__init__.py +++ /dev/null @@ -1,49 +0,0 @@ -""" -LAMMPS module global members: - -.. data:: __version__ - - Numerical representation of the LAMMPS version this - module was taken from. Has the same format as the - result of :py:func:`lammps.version`. -""" - -from .constants import * # lgtm [py/polluting-import] -from .core import * # lgtm [py/polluting-import] -from .data import * # lgtm [py/polluting-import] -from .pylammps import * # lgtm [py/polluting-import] - -# convert installed module string version to numeric version -def get_version_number(): - import time - from os.path import join - from sys import version_info - - # must report 0 when inside LAMMPS source tree - if __file__.find(join('python', 'lammps', '__init__.py')) > 0: - return 0 - - vstring = None - if version_info.major == 3 and version_info.minor >= 8: - from importlib.metadata import version, PackageNotFoundError - try: - vstring = version('lammps') - except PackageNotFoundError: - # nothing to do, ignore - pass - - else: - from pkg_resources import get_distribution, DistributionNotFound - try: - vstring = get_distribution('lammps').version - except DistributionNotFound: - # nothing to do, ignore - pass - - if not vstring: - return 0 - - t = time.strptime(vstring, "%Y.%m.%d") - return t.tm_year*10000 + t.tm_mon*100 + t.tm_mday - -__version__ = get_version_number() diff --git a/python/lammps/constants.py b/python/lammps/constants.py deleted file mode 100644 index a50d58b28f..0000000000 --- a/python/lammps/constants.py +++ /dev/null @@ -1,48 +0,0 @@ -# ---------------------------------------------------------------------- -# LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator -# https://www.lammps.org/ Sandia National Laboratories -# Steve Plimpton, sjplimp@sandia.gov -# -# Copyright (2003) Sandia Corporation. Under the terms of Contract -# DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains -# certain rights in this software. This software is distributed under -# the GNU General Public License. -# -# See the README file in the top-level LAMMPS directory. -# ------------------------------------------------------------------------- - -# various symbolic constants to be used -# in certain calls to select data formats -LAMMPS_AUTODETECT = None -LAMMPS_INT = 0 -LAMMPS_INT_2D = 1 -LAMMPS_DOUBLE = 2 -LAMMPS_DOUBLE_2D = 3 -LAMMPS_INT64 = 4 -LAMMPS_INT64_2D = 5 -LAMMPS_STRING = 6 - -# these must be kept in sync with the enums in library.h -LMP_STYLE_GLOBAL = 0 -LMP_STYLE_ATOM = 1 -LMP_STYLE_LOCAL = 2 - -LMP_TYPE_SCALAR = 0 -LMP_TYPE_VECTOR = 1 -LMP_TYPE_ARRAY = 2 -LMP_SIZE_VECTOR = 3 -LMP_SIZE_ROWS = 4 -LMP_SIZE_COLS = 5 - -LMP_VAR_EQUAL = 0 -LMP_VAR_ATOM = 1 - -# ------------------------------------------------------------------------- - -def get_ctypes_int(size): - from ctypes import c_int, c_int32, c_int64 - if size == 4: - return c_int32 - elif size == 8: - return c_int64 - return c_int diff --git a/python/lammps/core.py b/python/lammps/core.py deleted file mode 100644 index 930a40a4b0..0000000000 --- a/python/lammps/core.py +++ /dev/null @@ -1,2097 +0,0 @@ -# ---------------------------------------------------------------------- -# LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator -# https://www.lammps.org/ Sandia National Laboratories -# Steve Plimpton, sjplimp@sandia.gov -# -# Copyright (2003) Sandia Corporation. Under the terms of Contract -# DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains -# certain rights in this software. This software is distributed under -# the GNU General Public License. -# -# See the README file in the top-level LAMMPS directory. -# ------------------------------------------------------------------------- -# Python wrapper for the LAMMPS library via ctypes - -# for python2/3 compatibility - -from __future__ import print_function - -import os -import sys -from ctypes import * # lgtm [py/polluting-import] -from os.path import dirname,abspath,join -from inspect import getsourcefile - -from .constants import * # lgtm [py/polluting-import] -from .data import * # lgtm [py/polluting-import] - -# ------------------------------------------------------------------------- - -class MPIAbortException(Exception): - def __init__(self, message): - self.message = message - - def __str__(self): - return repr(self.message) - -# ------------------------------------------------------------------------- - -class ExceptionCheck: - """Utility class to rethrow LAMMPS C++ exceptions as Python exceptions""" - def __init__(self, lmp): - self.lmp = lmp - - def __enter__(self): - pass - - def __exit__(self, exc_type, exc_value, traceback): - if self.lmp.has_exceptions and self.lmp.lib.lammps_has_error(self.lmp.lmp): - raise self.lmp._lammps_exception - -# ------------------------------------------------------------------------- - -class lammps(object): - """Create an instance of the LAMMPS Python class. - - .. _mpi4py_docs: https://mpi4py.readthedocs.io/ - - This is a Python wrapper class that exposes the LAMMPS C-library - interface to Python. It either requires that LAMMPS has been compiled - as shared library which is then dynamically loaded via the ctypes - Python module or that this module called from a Python function that - is called from a Python interpreter embedded into a LAMMPS executable, - for example through the :doc:`python invoke ` command. - When the class is instantiated it calls the :cpp:func:`lammps_open` - function of the LAMMPS C-library interface, which in - turn will create an instance of the :cpp:class:`LAMMPS ` - C++ class. The handle to this C++ class is stored internally - and automatically passed to the calls to the C library interface. - - :param name: "machine" name of the shared LAMMPS library ("mpi" loads ``liblammps_mpi.so``, "" loads ``liblammps.so``) - :type name: string - :param cmdargs: list of command line arguments to be passed to the :cpp:func:`lammps_open` function. The executable name is automatically added. - :type cmdargs: list - :param ptr: pointer to a LAMMPS C++ class instance when called from an embedded Python interpreter. None means load symbols from shared library. - :type ptr: pointer - :param comm: MPI communicator (as provided by `mpi4py `_). ``None`` means use ``MPI_COMM_WORLD`` implicitly. - :type comm: MPI_Comm - """ - - # ------------------------------------------------------------------------- - # create an instance of LAMMPS - - def __init__(self,name='',cmdargs=None,ptr=None,comm=None): - self.comm = comm - self.opened = 0 - - # determine module file location - - modpath = dirname(abspath(getsourcefile(lambda:0))) - # for windows installers the shared library is in a different folder - winpath = abspath(os.path.join(modpath,'..','..','bin')) - # allow override for running tests on Windows - if (os.environ.get("LAMMPSDLLPATH")): - winpath = os.environ.get("LAMMPSDLLPATH") - self.lib = None - self.lmp = None - - # if a pointer to a LAMMPS object is handed in - # when being called from a Python interpreter - # embedded into a LAMMPS executable, all library - # symbols should already be available so we do not - # load a shared object. - - try: - if ptr is not None: self.lib = CDLL("",RTLD_GLOBAL) - except OSError: - self.lib = None - - # load liblammps.so unless name is given - # if name = "g++", load liblammps_g++.so - # try loading the LAMMPS shared object from the location - # of the lammps package with an absolute path, - # so that LD_LIBRARY_PATH does not need to be set for regular install - # fall back to loading with a relative path, - # typically requires LD_LIBRARY_PATH to be set appropriately - # guess shared library extension based on OS, if not inferred from actual file - - if any([f.startswith('liblammps') and f.endswith('.dylib') - for f in os.listdir(modpath)]): - lib_ext = ".dylib" - elif any([f.startswith('liblammps') and f.endswith('.dll') - for f in os.listdir(modpath)]): - lib_ext = ".dll" - elif os.path.exists(winpath) and any([f.startswith('liblammps') and f.endswith('.dll') - for f in os.listdir(winpath)]): - lib_ext = ".dll" - modpath = winpath - elif any([f.startswith('liblammps') and f.endswith('.so') - for f in os.listdir(modpath)]): - lib_ext = ".so" - else: - import platform - if platform.system() == "Darwin": - lib_ext = ".dylib" - elif platform.system() == "Windows": - lib_ext = ".dll" - else: - lib_ext = ".so" - - if not self.lib: - if name: - libpath = join(modpath,"liblammps_%s" % name + lib_ext) - else: - libpath = join(modpath,"liblammps" + lib_ext) - if not os.path.isfile(libpath): - if name: - libpath = "liblammps_%s" % name + lib_ext - else: - libpath = "liblammps" + lib_ext - self.lib = CDLL(libpath,RTLD_GLOBAL) - - # declare all argument and return types for all library methods here. - # exceptions are where the arguments depend on certain conditions and - # then are defined where the functions are used. - self.lib.lammps_extract_setting.argtypes = [c_void_p, c_char_p] - self.lib.lammps_extract_setting.restype = c_int - - # set default types - # needed in later declarations - self.c_bigint = get_ctypes_int(self.extract_setting("bigint")) - self.c_tagint = get_ctypes_int(self.extract_setting("tagint")) - self.c_imageint = get_ctypes_int(self.extract_setting("imageint")) - - self.lib.lammps_open.restype = c_void_p - self.lib.lammps_open_no_mpi.restype = c_void_p - self.lib.lammps_close.argtypes = [c_void_p] - self.lib.lammps_flush_buffers.argtypes = [c_void_p] - self.lib.lammps_free.argtypes = [c_void_p] - - self.lib.lammps_file.argtypes = [c_void_p, c_char_p] - self.lib.lammps_file.restype = None - - self.lib.lammps_command.argtypes = [c_void_p, c_char_p] - self.lib.lammps_command.restype = c_char_p - self.lib.lammps_commands_list.restype = None - self.lib.lammps_commands_string.argtypes = [c_void_p, c_char_p] - self.lib.lammps_commands_string.restype = None - - self.lib.lammps_get_natoms.argtypes = [c_void_p] - self.lib.lammps_get_natoms.restype = c_double - self.lib.lammps_extract_box.argtypes = \ - [c_void_p,POINTER(c_double),POINTER(c_double), - POINTER(c_double),POINTER(c_double),POINTER(c_double), - POINTER(c_int),POINTER(c_int)] - self.lib.lammps_extract_box.restype = None - - self.lib.lammps_reset_box.argtypes = \ - [c_void_p,POINTER(c_double),POINTER(c_double),c_double,c_double,c_double] - self.lib.lammps_reset_box.restype = None - - self.lib.lammps_gather_atoms.argtypes = [c_void_p,c_char_p,c_int,c_int,c_void_p] - self.lib.lammps_gather_atoms.restype = None - - self.lib.lammps_gather_atoms_concat.argtypes = [c_void_p,c_char_p,c_int,c_int,c_void_p] - self.lib.lammps_gather_atoms_concat.restype = None - - self.lib.lammps_gather_atoms_subset.argtypes = \ - [c_void_p,c_char_p,c_int,c_int,c_int,POINTER(c_int),c_void_p] - self.lib.lammps_gather_atoms_subset.restype = None - - self.lib.lammps_scatter_atoms.argtypes = [c_void_p,c_char_p,c_int,c_int,c_void_p] - self.lib.lammps_scatter_atoms.restype = None - - self.lib.lammps_scatter_atoms_subset.argtypes = \ - [c_void_p,c_char_p,c_int,c_int,c_int,POINTER(c_int),c_void_p] - self.lib.lammps_scatter_atoms_subset.restype = None - - self.lib.lammps_gather_bonds.argtypes = [c_void_p,c_void_p] - self.lib.lammps_gather_bonds.restype = None - - self.lib.lammps_gather.argtypes = [c_void_p,c_char_p,c_int,c_int,c_void_p] - self.lib.lammps_gather.restype = None - - self.lib.lammps_gather_concat.argtypes = [c_void_p,c_char_p,c_int,c_int,c_void_p] - self.lib.lammps_gather_concat.restype = None - - self.lib.lammps_gather_subset.argtypes = \ - [c_void_p,c_char_p,c_int,c_int,c_int,POINTER(c_int),c_void_p] - self.lib.lammps_gather_subset.restype = None - - self.lib.lammps_scatter.argtypes = [c_void_p,c_char_p,c_int,c_int,c_void_p] - self.lib.lammps_scatter.restype = None - - self.lib.lammps_scatter_subset.argtypes = \ - [c_void_p,c_char_p,c_int,c_int,c_int,POINTER(c_int),c_void_p] - self.lib.lammps_scatter_subset.restype = None - - - self.lib.lammps_find_pair_neighlist.argtypes = [c_void_p, c_char_p, c_int, c_int, c_int] - self.lib.lammps_find_pair_neighlist.restype = c_int - - self.lib.lammps_find_fix_neighlist.argtypes = [c_void_p, c_char_p, c_int] - self.lib.lammps_find_fix_neighlist.restype = c_int - - self.lib.lammps_find_compute_neighlist.argtypes = [c_void_p, c_char_p, c_int] - self.lib.lammps_find_compute_neighlist.restype = c_int - - self.lib.lammps_neighlist_num_elements.argtypes = [c_void_p, c_int] - self.lib.lammps_neighlist_num_elements.restype = c_int - - self.lib.lammps_neighlist_element_neighbors.argtypes = \ - [c_void_p, c_int, c_int, POINTER(c_int), POINTER(c_int), POINTER(POINTER(c_int))] - self.lib.lammps_neighlist_element_neighbors.restype = None - - self.lib.lammps_is_running.argtypes = [c_void_p] - self.lib.lammps_is_running.restype = c_int - - self.lib.lammps_force_timeout.argtypes = [c_void_p] - - self.lib.lammps_has_error.argtypes = [c_void_p] - self.lib.lammps_has_error.restype = c_int - - self.lib.lammps_get_last_error_message.argtypes = [c_void_p, c_char_p, c_int] - self.lib.lammps_get_last_error_message.restype = c_int - - self.lib.lammps_extract_global.argtypes = [c_void_p, c_char_p] - self.lib.lammps_extract_global_datatype.argtypes = [c_void_p, c_char_p] - self.lib.lammps_extract_global_datatype.restype = c_int - self.lib.lammps_extract_compute.argtypes = [c_void_p, c_char_p, c_int, c_int] - - self.lib.lammps_get_thermo.argtypes = [c_void_p, c_char_p] - self.lib.lammps_get_thermo.restype = c_double - - self.lib.lammps_encode_image_flags.restype = self.c_imageint - - self.lib.lammps_config_package_name.argtypes = [c_int, c_char_p, c_int] - self.lib.lammps_config_accelerator.argtypes = [c_char_p, c_char_p, c_char_p] - - self.lib.lammps_set_variable.argtypes = [c_void_p, c_char_p, c_char_p] - - self.lib.lammps_has_style.argtypes = [c_void_p, c_char_p, c_char_p] - - self.lib.lammps_style_count.argtypes = [c_void_p, c_char_p] - - self.lib.lammps_style_name.argtypes = [c_void_p, c_char_p, c_int, c_char_p, c_int] - - self.lib.lammps_has_id.argtypes = [c_void_p, c_char_p, c_char_p] - - self.lib.lammps_id_count.argtypes = [c_void_p, c_char_p] - - self.lib.lammps_id_name.argtypes = [c_void_p, c_char_p, c_int, c_char_p, c_int] - - self.lib.lammps_plugin_count.argtypes = [ ] - self.lib.lammps_plugin_name.argtypes = [c_int, c_char_p, c_char_p, c_int] - - self.lib.lammps_version.argtypes = [c_void_p] - - self.lib.lammps_get_os_info.argtypes = [c_char_p, c_int] - self.lib.lammps_get_gpu_device_info.argtypes = [c_char_p, c_int] - - self.lib.lammps_get_mpi_comm.argtypes = [c_void_p] - - self.lib.lammps_decode_image_flags.argtypes = [self.c_imageint, POINTER(c_int*3)] - - self.lib.lammps_extract_atom.argtypes = [c_void_p, c_char_p] - self.lib.lammps_extract_atom_datatype.argtypes = [c_void_p, c_char_p] - self.lib.lammps_extract_atom_datatype.restype = c_int - - self.lib.lammps_extract_fix.argtypes = [c_void_p, c_char_p, c_int, c_int, c_int, c_int] - - self.lib.lammps_extract_variable.argtypes = [c_void_p, c_char_p, c_char_p] - - self.lib.lammps_fix_external_get_force.argtypes = [c_void_p, c_char_p] - self.lib.lammps_fix_external_get_force.restype = POINTER(POINTER(c_double)) - - self.lib.lammps_fix_external_set_energy_global.argtypes = [c_void_p, c_char_p, c_double] - self.lib.lammps_fix_external_set_virial_global.argtypes = [c_void_p, c_char_p, POINTER(c_double)] - self.lib.lammps_fix_external_set_energy_peratom.argtypes = [c_void_p, c_char_p, POINTER(c_double)] - self.lib.lammps_fix_external_set_virial_peratom.argtypes = [c_void_p, c_char_p, POINTER(POINTER(c_double))] - - self.lib.lammps_fix_external_set_vector_length.argtypes = [c_void_p, c_char_p, c_int] - self.lib.lammps_fix_external_set_vector.argtypes = [c_void_p, c_char_p, c_int, c_double] - - # detect if Python is using a version of mpi4py that can pass communicators - # only needed if LAMMPS has been compiled with MPI support. - self.has_mpi4py = False - if self.has_mpi_support: - try: - from mpi4py import __version__ as mpi4py_version - # tested to work with mpi4py versions 2 and 3 - self.has_mpi4py = mpi4py_version.split('.')[0] in ['2','3'] - except ImportError: - # ignore failing import - pass - - # if no ptr provided, create an instance of LAMMPS - # we can pass an MPI communicator from mpi4py v2.0.0 and later - # no_mpi call lets LAMMPS use MPI_COMM_WORLD - # cargs = array of C strings from args - # if ptr, then are embedding Python in LAMMPS input script - # ptr is the desired instance of LAMMPS - # just convert it to ctypes ptr and store in self.lmp - - if ptr is None: - - # with mpi4py v2+, we can pass MPI communicators to LAMMPS - # need to adjust for type of MPI communicator object - # allow for int (like MPICH) or void* (like OpenMPI) - if self.has_mpi_support and self.has_mpi4py: - from mpi4py import MPI - self.MPI = MPI - - if comm is not None: - if not self.has_mpi_support: - raise Exception('LAMMPS not compiled with real MPI library') - if not self.has_mpi4py: - raise Exception('Python mpi4py version is not 2 or 3') - if self.MPI._sizeof(self.MPI.Comm) == sizeof(c_int): - MPI_Comm = c_int - else: - MPI_Comm = c_void_p - - # Detect whether LAMMPS and mpi4py definitely use different MPI libs - if sizeof(MPI_Comm) != self.lib.lammps_config_has_mpi_support(): - raise Exception('Inconsistent MPI library in LAMMPS and mpi4py') - - narg = 0 - cargs = None - if cmdargs is not None: - cmdargs.insert(0,"lammps") - narg = len(cmdargs) - for i in range(narg): - if type(cmdargs[i]) is str: - cmdargs[i] = cmdargs[i].encode() - cargs = (c_char_p*narg)(*cmdargs) - self.lib.lammps_open.argtypes = [c_int, c_char_p*narg, MPI_Comm, c_void_p] - else: - self.lib.lammps_open.argtypes = [c_int, c_char_p, MPI_Comm, c_void_p] - - self.opened = 1 - comm_ptr = self.MPI._addressof(comm) - comm_val = MPI_Comm.from_address(comm_ptr) - self.lmp = c_void_p(self.lib.lammps_open(narg,cargs,comm_val,None)) - - else: - if self.has_mpi4py and self.has_mpi_support: - self.comm = self.MPI.COMM_WORLD - self.opened = 1 - if cmdargs is not None: - cmdargs.insert(0,"lammps") - narg = len(cmdargs) - for i in range(narg): - if type(cmdargs[i]) is str: - cmdargs[i] = cmdargs[i].encode() - cargs = (c_char_p*narg)(*cmdargs) - self.lib.lammps_open_no_mpi.argtypes = [c_int, c_char_p*narg, c_void_p] - self.lmp = c_void_p(self.lib.lammps_open_no_mpi(narg,cargs,None)) - else: - self.lib.lammps_open_no_mpi.argtypes = [c_int, c_char_p, c_void_p] - self.lmp = c_void_p(self.lib.lammps_open_no_mpi(0,None,None)) - - else: - # magic to convert ptr to ctypes ptr - if sys.version_info >= (3, 0): - # Python 3 (uses PyCapsule API) - pythonapi.PyCapsule_GetPointer.restype = c_void_p - pythonapi.PyCapsule_GetPointer.argtypes = [py_object, c_char_p] - self.lmp = c_void_p(pythonapi.PyCapsule_GetPointer(ptr, None)) - else: - # Python 2 (uses PyCObject API) - pythonapi.PyCObject_AsVoidPtr.restype = c_void_p - pythonapi.PyCObject_AsVoidPtr.argtypes = [py_object] - self.lmp = c_void_p(pythonapi.PyCObject_AsVoidPtr(ptr)) - - # check if library initilialization failed - if not self.lmp: - raise(RuntimeError("Failed to initialize LAMMPS object")) - - # optional numpy support (lazy loading) - self._numpy = None - - self._installed_packages = None - self._available_styles = None - - # check if liblammps version matches the installed python module version - # but not for in-place usage, i.e. when the version is 0 - import lammps - if lammps.__version__ > 0 and lammps.__version__ != self.lib.lammps_version(self.lmp): - raise(AttributeError("LAMMPS Python module installed for LAMMPS version %d, but shared library is version %d" \ - % (lammps.__version__, self.lib.lammps_version(self.lmp)))) - - # add way to insert Python callback for fix external - self.callback = {} - self.FIX_EXTERNAL_CALLBACK_FUNC = CFUNCTYPE(None, py_object, self.c_bigint, c_int, POINTER(self.c_tagint), POINTER(POINTER(c_double)), POINTER(POINTER(c_double))) - self.lib.lammps_set_fix_external_callback.argtypes = [c_void_p, c_char_p, self.FIX_EXTERNAL_CALLBACK_FUNC, py_object] - self.lib.lammps_set_fix_external_callback.restype = None - - # ------------------------------------------------------------------------- - # shut-down LAMMPS instance - - def __del__(self): - self.close() - - # ------------------------------------------------------------------------- - # context manager implementation - - def __enter__(self): - return self - - def __exit__(self, ex_type, ex_value, ex_traceback): - self.close() - - # ------------------------------------------------------------------------- - - @property - def numpy(self): - """ Return object to access numpy versions of API - - It provides alternative implementations of API functions that - return numpy arrays instead of ctypes pointers. If numpy is not installed, - accessing this property will lead to an ImportError. - - :return: instance of numpy wrapper object - :rtype: numpy_wrapper - """ - if not self._numpy: - from .numpy_wrapper import numpy_wrapper - self._numpy = numpy_wrapper(self) - return self._numpy - - # ------------------------------------------------------------------------- - - def close(self): - """Explicitly delete a LAMMPS instance through the C-library interface. - - This is a wrapper around the :cpp:func:`lammps_close` function of the C-library interface. - """ - if self.lmp and self.opened: - self.lib.lammps_close(self.lmp) - self.lmp = None - self.opened = 0 - - # ------------------------------------------------------------------------- - - def finalize(self): - """Shut down the MPI communication and Kokkos environment (if active) through the - library interface by calling :cpp:func:`lammps_mpi_finalize` and - :cpp:func:`lammps_kokkos_finalize`. - - You cannot create or use any LAMMPS instances after this function is called - unless LAMMPS was compiled without MPI and without Kokkos support. - """ - self.close() - self.lib.lammps_kokkos_finalize() - self.lib.lammps_mpi_finalize() - - # ------------------------------------------------------------------------- - - def version(self): - """Return a numerical representation of the LAMMPS version in use. - - This is a wrapper around the :cpp:func:`lammps_version` function of the C-library interface. - - :return: version number - :rtype: int - """ - return self.lib.lammps_version(self.lmp) - - # ------------------------------------------------------------------------- - - def get_os_info(self): - """Return a string with information about the OS and compiler runtime - - This is a wrapper around the :cpp:func:`lammps_get_os_info` function of the C-library interface. - - :return: OS info string - :rtype: string - """ - - sb = create_string_buffer(512) - self.lib.lammps_get_os_info(sb,512) - return sb.value.decode() - - # ------------------------------------------------------------------------- - - def get_mpi_comm(self): - """Get the MPI communicator in use by the current LAMMPS instance - - This is a wrapper around the :cpp:func:`lammps_get_mpi_comm` function - of the C-library interface. It will return ``None`` if either the - LAMMPS library was compiled without MPI support or the mpi4py - Python module is not available. - - :return: MPI communicator - :rtype: MPI_Comm - """ - - if self.has_mpi4py and self.has_mpi_support: - from mpi4py import MPI - f_comm = self.lib.lammps_get_mpi_comm(self.lmp) - c_comm = MPI.Comm.f2py(f_comm) - return c_comm - else: - return None - - # ------------------------------------------------------------------------- - - @property - def _lammps_exception(self): - sb = create_string_buffer(100) - error_type = self.lib.lammps_get_last_error_message(self.lmp, sb, 100) - error_msg = sb.value.decode().strip() - - if error_type == 2: - return MPIAbortException(error_msg) - return Exception(error_msg) - - # ------------------------------------------------------------------------- - - def file(self, path): - """Read LAMMPS commands from a file. - - This is a wrapper around the :cpp:func:`lammps_file` function of the C-library interface. - It will open the file with the name/path `file` and process the LAMMPS commands line by line until - the end. The function will return when the end of the file is reached. - - :param path: Name of the file/path with LAMMPS commands - :type path: string - """ - if path: path = path.encode() - else: return - - with ExceptionCheck(self): - self.lib.lammps_file(self.lmp, path) - - # ------------------------------------------------------------------------- - - def command(self,cmd): - """Process a single LAMMPS input command from a string. - - This is a wrapper around the :cpp:func:`lammps_command` - function of the C-library interface. - - :param cmd: a single lammps command - :type cmd: string - """ - if cmd: cmd = cmd.encode() - else: return - - with ExceptionCheck(self): - self.lib.lammps_command(self.lmp,cmd) - - # ------------------------------------------------------------------------- - - def commands_list(self,cmdlist): - """Process multiple LAMMPS input commands from a list of strings. - - This is a wrapper around the - :cpp:func:`lammps_commands_list` function of - the C-library interface. - - :param cmdlist: a single lammps command - :type cmdlist: list of strings - """ - cmds = [x.encode() for x in cmdlist if type(x) is str] - narg = len(cmdlist) - args = (c_char_p * narg)(*cmds) - self.lib.lammps_commands_list.argtypes = [c_void_p, c_int, c_char_p * narg] - - with ExceptionCheck(self): - self.lib.lammps_commands_list(self.lmp,narg,args) - - # ------------------------------------------------------------------------- - - def commands_string(self,multicmd): - """Process a block of LAMMPS input commands from a string. - - This is a wrapper around the - :cpp:func:`lammps_commands_string` - function of the C-library interface. - - :param multicmd: text block of lammps commands - :type multicmd: string - """ - if type(multicmd) is str: multicmd = multicmd.encode() - - with ExceptionCheck(self): - self.lib.lammps_commands_string(self.lmp,c_char_p(multicmd)) - - # ------------------------------------------------------------------------- - - def get_natoms(self): - """Get the total number of atoms in the LAMMPS instance. - - Will be precise up to 53-bit signed integer due to the - underlying :cpp:func:`lammps_get_natoms` function returning a double. - - :return: number of atoms - :rtype: int - """ - return int(self.lib.lammps_get_natoms(self.lmp)) - - # ------------------------------------------------------------------------- - - def extract_box(self): - """Extract simulation box parameters - - This is a wrapper around the :cpp:func:`lammps_extract_box` function - of the C-library interface. Unlike in the C function, the result is - returned as a list. - - :return: list of the extracted data: boxlo, boxhi, xy, yz, xz, periodicity, box_change - :rtype: [ 3*double, 3*double, double, double, 3*int, int] - """ - boxlo = (3*c_double)() - boxhi = (3*c_double)() - xy = c_double() - yz = c_double() - xz = c_double() - periodicity = (3*c_int)() - box_change = c_int() - - with ExceptionCheck(self): - self.lib.lammps_extract_box(self.lmp,boxlo,boxhi, - byref(xy),byref(yz),byref(xz), - periodicity,byref(box_change)) - - boxlo = boxlo[:3] - boxhi = boxhi[:3] - xy = xy.value - yz = yz.value - xz = xz.value - periodicity = periodicity[:3] - box_change = box_change.value - - return boxlo,boxhi,xy,yz,xz,periodicity,box_change - - # ------------------------------------------------------------------------- - - def reset_box(self,boxlo,boxhi,xy,yz,xz): - """Reset simulation box parameters - - This is a wrapper around the :cpp:func:`lammps_reset_box` function - of the C-library interface. - - :param boxlo: new lower box boundaries - :type boxlo: list of 3 floating point numbers - :param boxhi: new upper box boundaries - :type boxhi: list of 3 floating point numbers - :param xy: xy tilt factor - :type xy: float - :param yz: yz tilt factor - :type yz: float - :param xz: xz tilt factor - :type xz: float - """ - cboxlo = (3*c_double)(*boxlo) - cboxhi = (3*c_double)(*boxhi) - with ExceptionCheck(self): - self.lib.lammps_reset_box(self.lmp,cboxlo,cboxhi,xy,yz,xz) - - # ------------------------------------------------------------------------- - - def get_thermo(self,name): - """Get current value of a thermo keyword - - This is a wrapper around the :cpp:func:`lammps_get_thermo` - function of the C-library interface. - - :param name: name of thermo keyword - :type name: string - :return: value of thermo keyword - :rtype: double or None - """ - if name: name = name.encode() - else: return None - - with ExceptionCheck(self): - return self.lib.lammps_get_thermo(self.lmp,name) - - # ------------------------------------------------------------------------- - - def extract_setting(self, name): - """Query LAMMPS about global settings that can be expressed as an integer. - - This is a wrapper around the :cpp:func:`lammps_extract_setting` - function of the C-library interface. Its documentation includes - a list of the supported keywords. - - :param name: name of the setting - :type name: string - :return: value of the setting - :rtype: int - """ - if name: name = name.encode() - else: return None - return int(self.lib.lammps_extract_setting(self.lmp,name)) - - # ------------------------------------------------------------------------- - # extract global info datatype - - def extract_global_datatype(self, name): - """Retrieve global property datatype from LAMMPS - - This is a wrapper around the :cpp:func:`lammps_extract_global_datatype` - function of the C-library interface. Its documentation includes a - list of the supported keywords. - This function returns ``None`` if the keyword is not - recognized. Otherwise it will return a positive integer value that - corresponds to one of the :ref:`data type ` - constants define in the :py:mod:`lammps` module. - - :param name: name of the property - :type name: string - :return: data type of global property, see :ref:`py_datatype_constants` - :rtype: int - """ - if name: name = name.encode() - else: return None - return self.lib.lammps_extract_global_datatype(self.lmp, name) - - # ------------------------------------------------------------------------- - # extract global info - - def extract_global(self, name, dtype=LAMMPS_AUTODETECT): - """Query LAMMPS about global settings of different types. - - This is a wrapper around the :cpp:func:`lammps_extract_global` function - of the C-library interface. Since there are no pointers in Python, this - method will - unlike the C function - return the value or a list of - values. The :cpp:func:`lammps_extract_global` documentation includes a - list of the supported keywords and their data types. - Since Python needs to know the data type to be able to interpret - the result, by default, this function will try to auto-detect the data type - by asking the library. You can also force a specific data type. For that - purpose the :py:mod:`lammps` module contains :ref:`data type ` - constants. This function returns ``None`` if either the keyword is not recognized, - or an invalid data type constant is used. - - :param name: name of the property - :type name: string - :param dtype: data type of the returned data (see :ref:`py_datatype_constants`) - :type dtype: int, optional - :return: value of the property or list of values or None - :rtype: int, float, list, or NoneType - """ - - if dtype == LAMMPS_AUTODETECT: - dtype = self.extract_global_datatype(name) - - # set length of vector for items that are not a scalar - vec_dict = { 'boxlo':3, 'boxhi':3, 'sublo':3, 'subhi':3, - 'sublo_lambda':3, 'subhi_lambda':3, 'periodicity':3 } - if name in vec_dict: - veclen = vec_dict[name] - elif name == 'respa_dt': - veclen = self.extract_global('respa_levels',LAMMPS_INT) - else: - veclen = 1 - - if name: name = name.encode() - else: return None - - if dtype == LAMMPS_INT: - self.lib.lammps_extract_global.restype = POINTER(c_int32) - target_type = int - elif dtype == LAMMPS_INT64: - self.lib.lammps_extract_global.restype = POINTER(c_int64) - target_type = int - elif dtype == LAMMPS_DOUBLE: - self.lib.lammps_extract_global.restype = POINTER(c_double) - target_type = float - elif dtype == LAMMPS_STRING: - self.lib.lammps_extract_global.restype = c_char_p - target_type = str - else: - target_type = None - - ptr = self.lib.lammps_extract_global(self.lmp, name) - if ptr: - if dtype == LAMMPS_STRING: - return ptr.decode('utf-8') - if veclen > 1: - result = [] - for i in range(0,veclen): - result.append(target_type(ptr[i])) - return result - else: return target_type(ptr[0]) - return None - - # ------------------------------------------------------------------------- - # extract per-atom info datatype - - def extract_atom_datatype(self, name): - """Retrieve per-atom property datatype from LAMMPS - - This is a wrapper around the :cpp:func:`lammps_extract_atom_datatype` - function of the C-library interface. Its documentation includes a - list of the supported keywords. - This function returns ``None`` if the keyword is not - recognized. Otherwise it will return an integer value that - corresponds to one of the :ref:`data type ` constants - defined in the :py:mod:`lammps` module. - - :param name: name of the property - :type name: string - :return: data type of per-atom property (see :ref:`py_datatype_constants`) - :rtype: int - """ - if name: name = name.encode() - else: return None - return self.lib.lammps_extract_atom_datatype(self.lmp, name) - - # ------------------------------------------------------------------------- - # extract per-atom info - - def extract_atom(self, name, dtype=LAMMPS_AUTODETECT): - """Retrieve per-atom properties from LAMMPS - - This is a wrapper around the :cpp:func:`lammps_extract_atom` - function of the C-library interface. Its documentation includes a - list of the supported keywords and their data types. - Since Python needs to know the data type to be able to interpret - the result, by default, this function will try to auto-detect the data type - by asking the library. You can also force a specific data type by setting ``dtype`` - to one of the :ref:`data type ` constants defined in the - :py:mod:`lammps` module. - This function returns ``None`` if either the keyword is not - recognized, or an invalid data type constant is used. - - .. note:: - - While the returned arrays of per-atom data are dimensioned - for the range [0:nmax] - as is the underlying storage - - the data is usually only valid for the range of [0:nlocal], - unless the property of interest is also updated for ghost - atoms. In some cases, this depends on a LAMMPS setting, see - for example :doc:`comm_modify vel yes `. - - :param name: name of the property - :type name: string - :param dtype: data type of the returned data (see :ref:`py_datatype_constants`) - :type dtype: int, optional - :return: requested data or ``None`` - :rtype: ctypes.POINTER(ctypes.c_int32), ctypes.POINTER(ctypes.POINTER(ctypes.c_int32)), - ctypes.POINTER(ctypes.c_int64), ctypes.POINTER(ctypes.POINTER(ctypes.c_int64)), - ctypes.POINTER(ctypes.c_double), ctypes.POINTER(ctypes.POINTER(ctypes.c_double)), - or NoneType - """ - if dtype == LAMMPS_AUTODETECT: - dtype = self.extract_atom_datatype(name) - - if name: name = name.encode() - else: return None - - if dtype == LAMMPS_INT: - self.lib.lammps_extract_atom.restype = POINTER(c_int32) - elif dtype == LAMMPS_INT_2D: - self.lib.lammps_extract_atom.restype = POINTER(POINTER(c_int32)) - elif dtype == LAMMPS_DOUBLE: - self.lib.lammps_extract_atom.restype = POINTER(c_double) - elif dtype == LAMMPS_DOUBLE_2D: - self.lib.lammps_extract_atom.restype = POINTER(POINTER(c_double)) - elif dtype == LAMMPS_INT64: - self.lib.lammps_extract_atom.restype = POINTER(c_int64) - elif dtype == LAMMPS_INT64_2D: - self.lib.lammps_extract_atom.restype = POINTER(POINTER(c_int64)) - else: return None - - ptr = self.lib.lammps_extract_atom(self.lmp, name) - if ptr: return ptr - else: return None - - - # ------------------------------------------------------------------------- - - def extract_compute(self,cid,cstyle,ctype): - """Retrieve data from a LAMMPS compute - - This is a wrapper around the :cpp:func:`lammps_extract_compute` - function of the C-library interface. - This function returns ``None`` if either the compute id is not - recognized, or an invalid combination of :ref:`cstyle ` - and :ref:`ctype ` constants is used. The - names and functionality of the constants are the same as for - the corresponding C-library function. For requests to return - a scalar or a size, the value is returned, otherwise a pointer. - - :param cid: compute ID - :type cid: string - :param cstyle: style of the data retrieve (global, atom, or local), see :ref:`py_style_constants` - :type cstyle: int - :param ctype: type or size of the returned data (scalar, vector, or array), see :ref:`py_type_constants` - :type ctype: int - :return: requested data as scalar, pointer to 1d or 2d double array, or None - :rtype: c_double, ctypes.POINTER(c_double), ctypes.POINTER(ctypes.POINTER(c_double)), or NoneType - """ - if cid: cid = cid.encode() - else: return None - - if ctype == LMP_TYPE_SCALAR: - if cstyle == LMP_STYLE_GLOBAL: - self.lib.lammps_extract_compute.restype = POINTER(c_double) - with ExceptionCheck(self): - ptr = self.lib.lammps_extract_compute(self.lmp,cid,cstyle,ctype) - return ptr[0] - elif cstyle == LMP_STYLE_ATOM: - return None - elif cstyle == LMP_STYLE_LOCAL: - self.lib.lammps_extract_compute.restype = POINTER(c_int) - with ExceptionCheck(self): - ptr = self.lib.lammps_extract_compute(self.lmp,cid,cstyle,ctype) - return ptr[0] - - elif ctype == LMP_TYPE_VECTOR: - self.lib.lammps_extract_compute.restype = POINTER(c_double) - with ExceptionCheck(self): - ptr = self.lib.lammps_extract_compute(self.lmp,cid,cstyle,ctype) - return ptr - - elif ctype == LMP_TYPE_ARRAY: - self.lib.lammps_extract_compute.restype = POINTER(POINTER(c_double)) - with ExceptionCheck(self): - ptr = self.lib.lammps_extract_compute(self.lmp,cid,cstyle,ctype) - return ptr - - elif ctype == LMP_SIZE_COLS: - if cstyle == LMP_STYLE_GLOBAL or cstyle == LMP_STYLE_ATOM or cstyle == LMP_STYLE_LOCAL: - self.lib.lammps_extract_compute.restype = POINTER(c_int) - with ExceptionCheck(self): - ptr = self.lib.lammps_extract_compute(self.lmp,cid,cstyle,ctype) - return ptr[0] - - elif ctype == LMP_SIZE_VECTOR or ctype == LMP_SIZE_ROWS: - if cstyle == LMP_STYLE_GLOBAL or cstyle == LMP_STYLE_LOCAL: - self.lib.lammps_extract_compute.restype = POINTER(c_int) - with ExceptionCheck(self): - ptr = self.lib.lammps_extract_compute(self.lmp,cid,cstyle,ctype) - return ptr[0] - - return None - - # ------------------------------------------------------------------------- - # extract fix info - # in case of global data, free memory for 1 double via lammps_free() - # double was allocated by library interface function - - def extract_fix(self,fid,fstyle,ftype,nrow=0,ncol=0): - """Retrieve data from a LAMMPS fix - - This is a wrapper around the :cpp:func:`lammps_extract_fix` - function of the C-library interface. - This function returns ``None`` if either the fix id is not - recognized, or an invalid combination of :ref:`fstyle ` - and :ref:`ftype ` constants is used. The - names and functionality of the constants are the same as for - the corresponding C-library function. For requests to return - a scalar or a size, the value is returned, also when accessing - global vectors or arrays, otherwise a pointer. - - :param fid: fix ID - :type fid: string - :param fstyle: style of the data retrieve (global, atom, or local), see :ref:`py_style_constants` - :type fstyle: int - :param ftype: type or size of the returned data (scalar, vector, or array), see :ref:`py_type_constants` - :type ftype: int - :param nrow: index of global vector element or row index of global array element - :type nrow: int - :param ncol: column index of global array element - :type ncol: int - :return: requested data or None - :rtype: c_double, ctypes.POINTER(c_double), ctypes.POINTER(ctypes.POINTER(c_double)), or NoneType - - """ - if fid: fid = fid.encode() - else: return None - - if fstyle == LMP_STYLE_GLOBAL: - if ftype in (LMP_TYPE_SCALAR, LMP_TYPE_VECTOR, LMP_TYPE_ARRAY): - self.lib.lammps_extract_fix.restype = POINTER(c_double) - with ExceptionCheck(self): - ptr = self.lib.lammps_extract_fix(self.lmp,fid,fstyle,ftype,nrow,ncol) - result = ptr[0] - self.lib.lammps_free(ptr) - return result - elif ftype in (LMP_SIZE_VECTOR, LMP_SIZE_ROWS, LMP_SIZE_COLS): - self.lib.lammps_extract_fix.restype = POINTER(c_int) - with ExceptionCheck(self): - ptr = self.lib.lammps_extract_fix(self.lmp,fid,fstyle,ftype,nrow,ncol) - return ptr[0] - else: - return None - - elif fstyle == LMP_STYLE_ATOM: - if ftype == LMP_TYPE_VECTOR: - self.lib.lammps_extract_fix.restype = POINTER(c_double) - elif ftype == LMP_TYPE_ARRAY: - self.lib.lammps_extract_fix.restype = POINTER(POINTER(c_double)) - elif ftype == LMP_SIZE_COLS: - self.lib.lammps_extract_fix.restype = POINTER(c_int) - else: - return None - with ExceptionCheck(self): - ptr = self.lib.lammps_extract_fix(self.lmp,fid,fstyle,ftype,nrow,ncol) - if ftype == LMP_SIZE_COLS: - return ptr[0] - else: - return ptr - - elif fstyle == LMP_STYLE_LOCAL: - if ftype == LMP_TYPE_VECTOR: - self.lib.lammps_extract_fix.restype = POINTER(c_double) - elif ftype == LMP_TYPE_ARRAY: - self.lib.lammps_extract_fix.restype = POINTER(POINTER(c_double)) - elif ftype in (LMP_TYPE_SCALAR, LMP_SIZE_VECTOR, LMP_SIZE_ROWS, LMP_SIZE_COLS): - self.lib.lammps_extract_fix.restype = POINTER(c_int) - else: - return None - with ExceptionCheck(self): - ptr = self.lib.lammps_extract_fix(self.lmp,fid,fstyle,ftype,nrow,ncol) - if ftype in (LMP_TYPE_VECTOR, LMP_TYPE_ARRAY): - return ptr - else: - return ptr[0] - else: - return None - - # ------------------------------------------------------------------------- - # extract variable info - # free memory for 1 double or 1 vector of doubles via lammps_free() - # for vector, must copy nlocal returned values to local c_double vector - # memory was allocated by library interface function - - def extract_variable(self, name, group=None, vartype=LMP_VAR_EQUAL): - """ Evaluate a LAMMPS variable and return its data - - This function is a wrapper around the function - :cpp:func:`lammps_extract_variable` of the C-library interface, - evaluates variable name and returns a copy of the computed data. - The memory temporarily allocated by the C-interface is deleted - after the data is copied to a Python variable or list. - The variable must be either an equal-style (or equivalent) - variable or an atom-style variable. The variable type has to - provided as ``vartype`` parameter which may be one of two constants: - ``LMP_VAR_EQUAL`` or ``LMP_VAR_ATOM``; it defaults to - equal-style variables. - The group parameter is only used for atom-style variables and - defaults to the group "all" if set to ``None``, which is the default. - - :param name: name of the variable to execute - :type name: string - :param group: name of group for atom-style variable - :type group: string, only for atom-style variables - :param vartype: type of variable, see :ref:`py_vartype_constants` - :type vartype: int - :return: the requested data - :rtype: c_double, (c_double), or NoneType - """ - if name: name = name.encode() - else: return None - if group: group = group.encode() - if vartype == LMP_VAR_EQUAL: - self.lib.lammps_extract_variable.restype = POINTER(c_double) - with ExceptionCheck(self): - ptr = self.lib.lammps_extract_variable(self.lmp,name,group) - if ptr: result = ptr[0] - else: return None - self.lib.lammps_free(ptr) - return result - elif vartype == LMP_VAR_ATOM: - nlocal = self.extract_global("nlocal") - result = (c_double*nlocal)() - self.lib.lammps_extract_variable.restype = POINTER(c_double) - with ExceptionCheck(self): - ptr = self.lib.lammps_extract_variable(self.lmp,name,group) - if ptr: - for i in range(nlocal): result[i] = ptr[i] - self.lib.lammps_free(ptr) - else: return None - return result - return None - - # ------------------------------------------------------------------------- - - def flush_buffers(self): - """Flush output buffers - - This is a wrapper around the :cpp:func:`lammps_flush_buffers` - function of the C-library interface. - """ - self.lib.lammps_flush_buffers(self.lmp) - - # ------------------------------------------------------------------------- - - def set_variable(self,name,value): - """Set a new value for a LAMMPS string style variable - - This is a wrapper around the :cpp:func:`lammps_set_variable` - function of the C-library interface. - - :param name: name of the variable - :type name: string - :param value: new variable value - :type value: any. will be converted to a string - :return: either 0 on success or -1 on failure - :rtype: int - """ - if name: name = name.encode() - else: return -1 - if value: value = str(value).encode() - else: return -1 - with ExceptionCheck(self): - return self.lib.lammps_set_variable(self.lmp,name,value) - - # ------------------------------------------------------------------------- - - # return vector of atom properties gathered across procs - # 3 variants to match src/library.cpp - # name = atom property recognized by LAMMPS in atom->extract() - # dtype = 0 for integer values, 1 for double values - # count = number of per-atom valus, 1 for type or charge, 3 for x or f - # returned data is a 1d vector - doc how it is ordered? - # NOTE: need to insure are converting to/from correct Python type - # e.g. for Python list or NumPy or ctypes - - def gather_atoms(self,name,dtype,count): - if name: name = name.encode() - natoms = self.get_natoms() - with ExceptionCheck(self): - if dtype == 0: - data = ((count*natoms)*c_int)() - self.lib.lammps_gather_atoms(self.lmp,name,dtype,count,data) - elif dtype == 1: - data = ((count*natoms)*c_double)() - self.lib.lammps_gather_atoms(self.lmp,name,dtype,count,data) - else: - return None - return data - - # ------------------------------------------------------------------------- - - def gather_atoms_concat(self,name,dtype,count): - if name: name = name.encode() - natoms = self.get_natoms() - with ExceptionCheck(self): - if dtype == 0: - data = ((count*natoms)*c_int)() - self.lib.lammps_gather_atoms_concat(self.lmp,name,dtype,count,data) - elif dtype == 1: - data = ((count*natoms)*c_double)() - self.lib.lammps_gather_atoms_concat(self.lmp,name,dtype,count,data) - else: - return None - return data - - def gather_atoms_subset(self,name,dtype,count,ndata,ids): - if name: name = name.encode() - with ExceptionCheck(self): - if dtype == 0: - data = ((count*ndata)*c_int)() - self.lib.lammps_gather_atoms_subset(self.lmp,name,dtype,count,ndata,ids,data) - elif dtype == 1: - data = ((count*ndata)*c_double)() - self.lib.lammps_gather_atoms_subset(self.lmp,name,dtype,count,ndata,ids,data) - else: - return None - return data - - # ------------------------------------------------------------------------- - - # scatter vector of atom properties across procs - # 2 variants to match src/library.cpp - # name = atom property recognized by LAMMPS in atom->extract() - # type = 0 for integer values, 1 for double values - # count = number of per-atom valus, 1 for type or charge, 3 for x or f - # assume data is of correct type and length, as created by gather_atoms() - # NOTE: need to insure are converting to/from correct Python type - # e.g. for Python list or NumPy or ctypes - - def scatter_atoms(self,name,dtype,count,data): - if name: name = name.encode() - with ExceptionCheck(self): - self.lib.lammps_scatter_atoms(self.lmp,name,dtype,count,data) - - # ------------------------------------------------------------------------- - - def scatter_atoms_subset(self,name,dtype,count,ndata,ids,data): - if name: name = name.encode() - with ExceptionCheck(self): - self.lib.lammps_scatter_atoms_subset(self.lmp,name,dtype,count,ndata,ids,data) - - - # ------------------------------------------------------------------------- - - def gather_bonds(self): - """Retrieve global list of bonds - - This is a wrapper around the :cpp:func:`lammps_gather_bonds` - function of the C-library interface. - - This function returns a tuple with the number of bonds and a - flat list of ctypes integer values with the bond type, bond atom1, - bond atom2 for each bond. - - .. versionadded:: 28Jul2021 - - :return: a tuple with the number of bonds and a list of c_int or c_long - :rtype: (int, 3*nbonds*c_tagint) - """ - nbonds = self.extract_global("nbonds") - with ExceptionCheck(self): - data = ((3*nbonds)*self.c_tagint)() - self.lib.lammps_gather_bonds(self.lmp,data) - return nbonds,data - - # ------------------------------------------------------------------------- - - # return vector of atom/compute/fix properties gathered across procs - # 3 variants to match src/library.cpp - # name = atom property recognized by LAMMPS in atom->extract() - # type = 0 for integer values, 1 for double values - # count = number of per-atom valus, 1 for type or charge, 3 for x or f - # returned data is a 1d vector - doc how it is ordered? - # NOTE: need to insure are converting to/from correct Python type - # e.g. for Python list or NumPy or ctypes - def gather(self,name,dtype,count): - if name: name = name.encode() - natoms = self.get_natoms() - with ExceptionCheck(self): - if dtype == 0: - data = ((count*natoms)*c_int)() - self.lib.lammps_gather(self.lmp,name,dtype,count,data) - elif dtype == 1: - data = ((count*natoms)*c_double)() - self.lib.lammps_gather(self.lmp,name,dtype,count,data) - else: - return None - return data - - def gather_concat(self,name,dtype,count): - if name: name = name.encode() - natoms = self.get_natoms() - with ExceptionCheck(self): - if dtype == 0: - data = ((count*natoms)*c_int)() - self.lib.lammps_gather_concat(self.lmp,name,dtype,count,data) - elif dtype == 1: - data = ((count*natoms)*c_double)() - self.lib.lammps_gather_concat(self.lmp,name,dtype,count,data) - else: - return None - return data - - def gather_subset(self,name,dtype,count,ndata,ids): - if name: name = name.encode() - with ExceptionCheck(self): - if dtype == 0: - data = ((count*ndata)*c_int)() - self.lib.lammps_gather_subset(self.lmp,name,dtype,count,ndata,ids,data) - elif dtype == 1: - data = ((count*ndata)*c_double)() - self.lib.lammps_gather_subset(self.lmp,name,dtype,count,ndata,ids,data) - else: - return None - return data - - # scatter vector of atom/compute/fix properties across procs - # 2 variants to match src/library.cpp - # name = atom property recognized by LAMMPS in atom->extract() - # type = 0 for integer values, 1 for double values - # count = number of per-atom valus, 1 for type or charge, 3 for x or f - # assume data is of correct type and length, as created by gather_atoms() - # NOTE: need to insure are converting to/from correct Python type - # e.g. for Python list or NumPy or ctypes - - def scatter(self,name,dtype,count,data): - if name: name = name.encode() - with ExceptionCheck(self): - self.lib.lammps_scatter(self.lmp,name,dtype,count,data) - - def scatter_subset(self,name,dtype,count,ndata,ids,data): - if name: name = name.encode() - with ExceptionCheck(self): - self.lib.lammps_scatter_subset(self.lmp,name,dtype,count,ndata,ids,data) - - # ------------------------------------------------------------------------- - - def encode_image_flags(self,ix,iy,iz): - """ convert 3 integers with image flags for x-, y-, and z-direction - into a single integer like it is used internally in LAMMPS - - This method is a wrapper around the :cpp:func:`lammps_encode_image_flags` - function of library interface. - - :param ix: x-direction image flag - :type ix: int - :param iy: y-direction image flag - :type iy: int - :param iz: z-direction image flag - :type iz: int - :return: encoded image flags - :rtype: lammps.c_imageint - """ - return self.lib.lammps_encode_image_flags(ix,iy,iz) - - # ------------------------------------------------------------------------- - - def decode_image_flags(self,image): - """ Convert encoded image flag integer into list of three regular integers. - - This method is a wrapper around the :cpp:func:`lammps_decode_image_flags` - function of library interface. - - :param image: encoded image flags - :type image: lammps.c_imageint - :return: list of three image flags in x-, y-, and z- direction - :rtype: list of 3 int - """ - - flags = (c_int*3)() - self.lib.lammps_decode_image_flags(image,byref(flags)) - - return [int(i) for i in flags] - - # ------------------------------------------------------------------------- - - # create N atoms on all procs - # N = global number of atoms - # id = ID of each atom (optional, can be None) - # type = type of each atom (1 to Ntypes) (required) - # x = coords of each atom as (N,3) array (required) - # v = velocity of each atom as (N,3) array (optional, can be None) - # NOTE: how could we insure are passing correct type to LAMMPS - # e.g. for Python list or NumPy, etc - # ditto for gather_atoms() above - - def create_atoms(self,n,id,type,x,v=None,image=None,shrinkexceed=False): - """ - Create N atoms from list of coordinates and properties - - This function is a wrapper around the :cpp:func:`lammps_create_atoms` - function of the C-library interface, and the behavior is similar except - that the *v*, *image*, and *shrinkexceed* arguments are optional and - default to *None*, *None*, and *False*, respectively. With *None* being - equivalent to a ``NULL`` pointer in C. - - The lists of coordinates, types, atom IDs, velocities, image flags can - be provided in any format that may be converted into the required - internal data types. Also the list may contain more than *N* entries, - but not fewer. In the latter case, the function will return without - attempting to create atoms. You may use the :py:func:`encode_image_flags - ` method to properly combine three integers - with image flags into a single integer. - - :param n: number of atoms for which data is provided - :type n: int - :param id: list of atom IDs with at least n elements or None - :type id: list of lammps.tagint - :param type: list of atom types - :type type: list of int - :param x: list of coordinates for x-, y-, and z (flat list of 3n entries) - :type x: list of float - :param v: list of velocities for x-, y-, and z (flat list of 3n entries) or None (optional) - :type v: list of float - :param image: list of encoded image flags (optional) - :type image: list of lammps.imageint - :param shrinkexceed: whether to expand shrink-wrap boundaries if atoms are outside the box (optional) - :type shrinkexceed: bool - :return: number of atoms created. 0 if insufficient or invalid data - :rtype: int - """ - if id is not None: - id_lmp = (self.c_tagint*n)() - try: - id_lmp[:] = id[0:n] - except ValueError: - return 0 - else: - id_lmp = None - - type_lmp = (c_int*n)() - try: - type_lmp[:] = type[0:n] - except ValueError: - return 0 - - three_n = 3*n - x_lmp = (c_double*three_n)() - try: - x_lmp[:] = x[0:three_n] - except ValueError: - return 0 - - if v is not None: - v_lmp = (c_double*(three_n))() - try: - v_lmp[:] = v[0:three_n] - except ValueError: - return 0 - else: - v_lmp = None - - if image is not None: - img_lmp = (self.c_imageint*n)() - try: - img_lmp[:] = image[0:n] - except ValueError: - return 0 - else: - img_lmp = None - - if shrinkexceed: - se_lmp = 1 - else: - se_lmp = 0 - - self.lib.lammps_create_atoms.argtypes = [c_void_p, c_int, POINTER(self.c_tagint*n), - POINTER(c_int*n), POINTER(c_double*three_n), - POINTER(c_double*three_n), - POINTER(self.c_imageint*n), c_int] - with ExceptionCheck(self): - return self.lib.lammps_create_atoms(self.lmp, n, id_lmp, type_lmp, x_lmp, v_lmp, img_lmp, se_lmp) - - # ------------------------------------------------------------------------- - - @property - def has_mpi_support(self): - """ Report whether the LAMMPS shared library was compiled with a - real MPI library or in serial. - - This is a wrapper around the :cpp:func:`lammps_config_has_mpi_support` - function of the library interface. - - :return: False when compiled with MPI STUBS, otherwise True - :rtype: bool - """ - return self.lib.lammps_config_has_mpi_support() != 0 - - # ------------------------------------------------------------------------- - - @property - def is_running(self): - """ Report whether being called from a function during a run or a minimization - - Various LAMMPS commands must not be called during an ongoing - run or minimization. This property allows to check for that. - This is a wrapper around the :cpp:func:`lammps_is_running` - function of the library interface. - - .. versionadded:: 9Oct2020 - - :return: True when called during a run otherwise false - :rtype: bool - """ - return self.lib.lammps_is_running(self.lmp) == 1 - - # ------------------------------------------------------------------------- - - def force_timeout(self): - """ Trigger an immediate timeout, i.e. a "soft stop" of a run. - - This function allows to cleanly stop an ongoing run or minimization - at the next loop iteration. - This is a wrapper around the :cpp:func:`lammps_force_timeout` - function of the library interface. - - .. versionadded:: 9Oct2020 - """ - self.lib.lammps_force_timeout(self.lmp) - - # ------------------------------------------------------------------------- - - @property - def has_exceptions(self): - """ Report whether the LAMMPS shared library was compiled with C++ - exceptions handling enabled - - This is a wrapper around the :cpp:func:`lammps_config_has_exceptions` - function of the library interface. - - :return: state of C++ exception support - :rtype: bool - """ - return self.lib.lammps_config_has_exceptions() != 0 - - # ------------------------------------------------------------------------- - - @property - def has_gzip_support(self): - """ Report whether the LAMMPS shared library was compiled with support - for reading and writing compressed files through ``gzip``. - - This is a wrapper around the :cpp:func:`lammps_config_has_gzip_support` - function of the library interface. - - :return: state of gzip support - :rtype: bool - """ - return self.lib.lammps_config_has_gzip_support() != 0 - - # ------------------------------------------------------------------------- - - @property - def has_png_support(self): - """ Report whether the LAMMPS shared library was compiled with support - for writing images in PNG format. - - This is a wrapper around the :cpp:func:`lammps_config_has_png_support` - function of the library interface. - - :return: state of PNG support - :rtype: bool - """ - return self.lib.lammps_config_has_png_support() != 0 - - # ------------------------------------------------------------------------- - - @property - def has_jpeg_support(self): - """ Report whether the LAMMPS shared library was compiled with support - for writing images in JPEG format. - - This is a wrapper around the :cpp:func:`lammps_config_has_jpeg_support` - function of the library interface. - - :return: state of JPEG support - :rtype: bool - """ - return self.lib.lammps_config_has_jpeg_support() != 0 - - # ------------------------------------------------------------------------- - - @property - def has_ffmpeg_support(self): - """ State of support for writing movies with ``ffmpeg`` in the LAMMPS shared library - - This is a wrapper around the :cpp:func:`lammps_config_has_ffmpeg_support` - function of the library interface. - - :return: state of ffmpeg support - :rtype: bool - """ - return self.lib.lammps_config_has_ffmpeg_support() != 0 - - # ------------------------------------------------------------------------- - - @property - def accelerator_config(self): - """ Return table with available accelerator configuration settings. - - This is a wrapper around the :cpp:func:`lammps_config_accelerator` - function of the library interface which loops over all known packages - and categories and returns enabled features as a nested dictionary - with all enabled settings as list of strings. - - :return: nested dictionary with all known enabled settings as list of strings - :rtype: dictionary - """ - - result = {} - for p in ['GPU', 'KOKKOS', 'INTEL', 'OPENMP']: - result[p] = {} - c = 'api' - result[p][c] = [] - for s in ['cuda', 'hip', 'phi', 'pthreads', 'opencl', 'openmp', 'serial']: - if self.lib.lammps_config_accelerator(p.encode(),c.encode(),s.encode()): - result[p][c].append(s) - c = 'precision' - result[p][c] = [] - for s in ['double', 'mixed', 'single']: - if self.lib.lammps_config_accelerator(p.encode(),c.encode(),s.encode()): - result[p][c].append(s) - return result - - # ------------------------------------------------------------------------- - - @property - def has_gpu_device(self): - """ Availability of GPU package compatible device - - This is a wrapper around the :cpp:func:`lammps_has_gpu_device` - function of the C library interface. - - :return: True if a GPU package compatible device is present, otherwise False - :rtype: bool - """ - return self.lib.lammps_has_gpu_device() != 0 - - # ------------------------------------------------------------------------- - - def get_gpu_device_info(self): - """Return a string with detailed information about any devices that are - usable by the GPU package. - - This is a wrapper around the :cpp:func:`lammps_get_gpu_device_info` - function of the C-library interface. - - :return: GPU device info string - :rtype: string - """ - - sb = create_string_buffer(8192) - self.lib.lammps_get_gpu_device_info(sb,8192) - return sb.value.decode() - - # ------------------------------------------------------------------------- - - @property - def installed_packages(self): - """ List of the names of enabled packages in the LAMMPS shared library - - This is a wrapper around the functions :cpp:func:`lammps_config_package_count` - and :cpp:func`lammps_config_package_name` of the library interface. - - :return - """ - if self._installed_packages is None: - self._installed_packages = [] - npackages = self.lib.lammps_config_package_count() - sb = create_string_buffer(100) - for idx in range(npackages): - self.lib.lammps_config_package_name(idx, sb, 100) - self._installed_packages.append(sb.value.decode()) - return self._installed_packages - - # ------------------------------------------------------------------------- - - def has_style(self, category, name): - """Returns whether a given style name is available in a given category - - This is a wrapper around the function :cpp:func:`lammps_has_style` - of the library interface. - - :param category: name of category - :type category: string - :param name: name of the style - :type name: string - - :return: true if style is available in given category - :rtype: bool - """ - return self.lib.lammps_has_style(self.lmp, category.encode(), name.encode()) != 0 - - # ------------------------------------------------------------------------- - - def available_styles(self, category): - """Returns a list of styles available for a given category - - This is a wrapper around the functions :cpp:func:`lammps_style_count()` - and :cpp:func:`lammps_style_name()` of the library interface. - - :param category: name of category - :type category: string - - :return: list of style names in given category - :rtype: list - """ - if self._available_styles is None: - self._available_styles = {} - - if category not in self._available_styles: - self._available_styles[category] = [] - with ExceptionCheck(self): - nstyles = self.lib.lammps_style_count(self.lmp, category.encode()) - sb = create_string_buffer(100) - for idx in range(nstyles): - with ExceptionCheck(self): - self.lib.lammps_style_name(self.lmp, category.encode(), idx, sb, 100) - self._available_styles[category].append(sb.value.decode()) - return self._available_styles[category] - - # ------------------------------------------------------------------------- - - def has_id(self, category, name): - """Returns whether a given ID name is available in a given category - - This is a wrapper around the function :cpp:func:`lammps_has_id` - of the library interface. - - .. versionadded:: 9Oct2020 - - :param category: name of category - :type category: string - :param name: name of the ID - :type name: string - - :return: true if ID is available in given category - :rtype: bool - """ - return self.lib.lammps_has_id(self.lmp, category.encode(), name.encode()) != 0 - - # ------------------------------------------------------------------------- - - def available_ids(self, category): - """Returns a list of IDs available for a given category - - This is a wrapper around the functions :cpp:func:`lammps_id_count()` - and :cpp:func:`lammps_id_name()` of the library interface. - - .. versionadded:: 9Oct2020 - - :param category: name of category - :type category: string - - :return: list of id names in given category - :rtype: list - """ - - categories = ['compute','dump','fix','group','molecule','region','variable'] - available_ids = [] - if category in categories: - num = self.lib.lammps_id_count(self.lmp, category.encode()) - sb = create_string_buffer(100) - for idx in range(num): - self.lib.lammps_id_name(self.lmp, category.encode(), idx, sb, 100) - available_ids.append(sb.value.decode()) - return available_ids - - # ------------------------------------------------------------------------- - - def available_plugins(self, category): - """Returns a list of plugins available for a given category - - This is a wrapper around the functions :cpp:func:`lammps_plugin_count()` - and :cpp:func:`lammps_plugin_name()` of the library interface. - - .. versionadded:: 10Mar2021 - - :return: list of style/name pairs of loaded plugins - :rtype: list - """ - - available_plugins = [] - num = self.lib.lammps_plugin_count(self.lmp) - sty = create_string_buffer(100) - nam = create_string_buffer(100) - for idx in range(num): - self.lib.lammps_plugin_name(idx, sty, nam, 100) - available_plugins.append([sty.value.decode(), nam.value.decode()]) - return available_plugins - - # ------------------------------------------------------------------------- - - def set_fix_external_callback(self, fix_id, callback, caller=None): - """Set the callback function for a fix external instance with a given fix ID. - - Optionally also set a reference to the calling object. - - This is a wrapper around the :cpp:func:`lammps_set_fix_external_callback` function - of the C-library interface. However this is set up to call a Python function with - the following arguments. - - .. code-block: python - - def func(object, ntimestep, nlocal, tag, x, f): - - - object is the value of the "caller" argument - - ntimestep is the current timestep - - nlocal is the number of local atoms on the current MPI process - - tag is a 1d NumPy array of integers representing the atom IDs of the local atoms - - x is a 2d NumPy array of doubles of the coordinates of the local atoms - - f is a 2d NumPy array of doubles of the forces on the local atoms that will be added - - .. versionchanged:: 28Jul2021 - - :param fix_id: Fix-ID of a fix external instance - :type: string - :param callback: Python function that will be called from fix external - :type: function - :param caller: reference to some object passed to the callback function - :type: object, optional - """ - import numpy as np - - def callback_wrapper(caller, ntimestep, nlocal, tag_ptr, x_ptr, fext_ptr): - tag = self.numpy.iarray(self.c_tagint, tag_ptr, nlocal, 1) - x = self.numpy.darray(x_ptr, nlocal, 3) - f = self.numpy.darray(fext_ptr, nlocal, 3) - callback(caller, ntimestep, nlocal, tag, x, f) - - cFunc = self.FIX_EXTERNAL_CALLBACK_FUNC(callback_wrapper) - cCaller = caller - - self.callback[fix_id] = { 'function': cFunc, 'caller': caller } - with ExceptionCheck(self): - self.lib.lammps_set_fix_external_callback(self.lmp, fix_id.encode(), cFunc, cCaller) - - # ------------------------------------------------------------------------- - - def fix_external_get_force(self, fix_id): - """Get access to the array with per-atom forces of a fix external instance with a given fix ID. - - This is a wrapper around the :cpp:func:`lammps_fix_external_get_force` function - of the C-library interface. - - .. versionadded:: 28Jul2021 - - :param fix_id: Fix-ID of a fix external instance - :type: string - :return: requested data - :rtype: ctypes.POINTER(ctypes.POINTER(ctypes.double)) - """ - - with ExceptionCheck(self): - return self.lib.lammps_fix_external_get_force(self.lmp, fix_id.encode()) - - # ------------------------------------------------------------------------- - - def fix_external_set_energy_global(self, fix_id, eng): - """Set the global energy contribution for a fix external instance with the given ID. - - This is a wrapper around the :cpp:func:`lammps_fix_external_set_energy_global` function - of the C-library interface. - - .. versionadded:: 28Jul2021 - - :param fix_id: Fix-ID of a fix external instance - :type: string - :param eng: potential energy value to be added by fix external - :type: float - """ - - with ExceptionCheck(self): - return self.lib.lammps_fix_external_set_energy_global(self.lmp, fix_id.encode(), eng) - - # ------------------------------------------------------------------------- - - def fix_external_set_virial_global(self, fix_id, virial): - """Set the global virial contribution for a fix external instance with the given ID. - - This is a wrapper around the :cpp:func:`lammps_fix_external_set_virial_global` function - of the C-library interface. - - .. versionadded:: 28Jul2021 - - :param fix_id: Fix-ID of a fix external instance - :type: string - :param eng: list of 6 floating point numbers with the virial to be added by fix external - :type: float - """ - - cvirial = (6*c_double)(*virial) - with ExceptionCheck(self): - return self.lib.lammps_fix_external_set_virial_global(self.lmp, fix_id.encode(), cvirial) - - # ------------------------------------------------------------------------- - - def fix_external_set_energy_peratom(self, fix_id, eatom): - """Set the per-atom energy contribution for a fix external instance with the given ID. - - This is a wrapper around the :cpp:func:`lammps_fix_external_set_energy_peratom` function - of the C-library interface. - - .. versionadded:: 28Jul2021 - - :param fix_id: Fix-ID of a fix external instance - :type: string - :param eatom: list of potential energy values for local atoms to be added by fix external - :type: float - """ - - nlocal = self.extract_setting('nlocal') - if len(eatom) < nlocal: - raise Exception('per-atom energy list length must be at least nlocal') - ceatom = (nlocal*c_double)(*eatom) - with ExceptionCheck(self): - return self.lib.lammps_fix_external_set_energy_peratom(self.lmp, fix_id.encode(), ceatom) - - # ------------------------------------------------------------------------- - - def fix_external_set_virial_peratom(self, fix_id, vatom): - """Set the per-atom virial contribution for a fix external instance with the given ID. - - This is a wrapper around the :cpp:func:`lammps_fix_external_set_virial_peratom` function - of the C-library interface. - - .. versionadded:: 28Jul2021 - - :param fix_id: Fix-ID of a fix external instance - :type: string - :param vatom: list of natoms lists with 6 floating point numbers to be added by fix external - :type: float - """ - - # copy virial data to C compatible buffer - nlocal = self.extract_setting('nlocal') - if len(vatom) < nlocal: - raise Exception('per-atom virial first dimension must be at least nlocal') - if len(vatom[0]) != 6: - raise Exception('per-atom virial second dimension must be 6') - vbuf = (c_double * 6) - vptr = POINTER(c_double) - c_virial = (vptr * nlocal)() - for i in range(nlocal): - c_virial[i] = vbuf() - for j in range(6): - c_virial[i][j] = vatom[i][j] - - with ExceptionCheck(self): - return self.lib.lammps_fix_external_set_virial_peratom(self.lmp, fix_id.encode(), c_virial) - - # ------------------------------------------------------------------------- - def fix_external_set_vector_length(self, fix_id, length): - """Set the vector length for a global vector stored with fix external for analysis - - This is a wrapper around the :cpp:func:`lammps_fix_external_set_vector_length` function - of the C-library interface. - - .. versionadded:: 28Jul2021 - - :param fix_id: Fix-ID of a fix external instance - :type: string - :param length: length of the global vector - :type: int - """ - - with ExceptionCheck(self): - return self.lib.lammps_fix_external_set_vector_length(self.lmp, fix_id.encode(), length) - - # ------------------------------------------------------------------------- - def fix_external_set_vector(self, fix_id, idx, val): - """Store a global vector value for a fix external instance with the given ID. - - This is a wrapper around the :cpp:func:`lammps_fix_external_set_vector` function - of the C-library interface. - - .. versionadded:: 28Jul2021 - - :param fix_id: Fix-ID of a fix external instance - :type: string - :param idx: 1-based index of the value in the global vector - :type: int - :param val: value to be stored in the global vector - :type: float - """ - - with ExceptionCheck(self): - return self.lib.lammps_fix_external_set_vector(self.lmp, fix_id.encode(), idx, val) - - # ------------------------------------------------------------------------- - - def get_neighlist(self, idx): - """Returns an instance of :class:`NeighList` which wraps access to the neighbor list with the given index - - See :py:meth:`lammps.numpy.get_neighlist() ` if you want to use - NumPy arrays instead of ``c_int`` pointers. - - :param idx: index of neighbor list - :type idx: int - :return: an instance of :class:`NeighList` wrapping access to neighbor list data - :rtype: NeighList - """ - if idx < 0: - return None - return NeighList(self, idx) - - # ------------------------------------------------------------------------- - - def get_neighlist_size(self, idx): - """Return the number of elements in neighbor list with the given index - - :param idx: neighbor list index - :type idx: int - :return: number of elements in neighbor list with index idx - :rtype: int - """ - return self.lib.lammps_neighlist_num_elements(self.lmp, idx) - - # ------------------------------------------------------------------------- - - def get_neighlist_element_neighbors(self, idx, element): - """Return data of neighbor list entry - - :param element: neighbor list index - :type element: int - :param element: neighbor list element index - :type element: int - :return: tuple with atom local index, number of neighbors and array of neighbor local atom indices - :rtype: (int, int, POINTER(c_int)) - """ - c_iatom = c_int() - c_numneigh = c_int() - c_neighbors = POINTER(c_int)() - self.lib.lammps_neighlist_element_neighbors(self.lmp, idx, element, byref(c_iatom), byref(c_numneigh), byref(c_neighbors)) - return c_iatom.value, c_numneigh.value, c_neighbors - - # ------------------------------------------------------------------------- - - def find_pair_neighlist(self, style, exact=True, nsub=0, reqid=0): - """Find neighbor list index of pair style neighbor list - - Search for a neighbor list requested by a pair style instance that - matches "style". If exact is True, the pair style name must match - exactly. If exact is False, the pair style name is matched against - "style" as regular expression or sub-string. If the pair style is a - hybrid pair style, the style is instead matched against the hybrid - sub-styles. If the same pair style is used as sub-style multiple - types, you must set nsub to a value n > 0 which indicates the nth - instance of that sub-style to be used (same as for the pair_coeff - command). The default value of 0 will fail to match in that case. - - Once the pair style instance has been identified, it may have - requested multiple neighbor lists. Those are uniquely identified by - a request ID > 0 as set by the pair style. Otherwise the request - ID is 0. - - :param style: name of pair style that should be searched for - :type style: string - :param exact: controls whether style should match exactly or only must be contained in pair style name, defaults to True - :type exact: bool, optional - :param nsub: match nsub-th hybrid sub-style, defaults to 0 - :type nsub: int, optional - :param reqid: list request id, > 0 in case there are more than one, defaults to 0 - :type reqid: int, optional - :return: neighbor list index if found, otherwise -1 - :rtype: int - - """ - style = style.encode() - exact = int(exact) - idx = self.lib.lammps_find_pair_neighlist(self.lmp, style, exact, nsub, reqid) - return idx - - # ------------------------------------------------------------------------- - - def find_fix_neighlist(self, fixid, reqid=0): - """Find neighbor list index of fix neighbor list - - The fix instance requesting the neighbor list is uniquely identified - by the fix ID. In case the fix has requested multiple neighbor - lists, those are uniquely identified by a request ID > 0 as set by - the fix. Otherwise the request ID is 0 (the default). - - :param fixid: name of fix - :type fixid: string - :param reqid: id of neighbor list request, in case there are more than one request, defaults to 0 - :type reqid: int, optional - :return: neighbor list index if found, otherwise -1 - :rtype: int - - """ - fixid = fixid.encode() - idx = self.lib.lammps_find_fix_neighlist(self.lmp, fixid, reqid) - return idx - - # ------------------------------------------------------------------------- - - def find_compute_neighlist(self, computeid, reqid=0): - """Find neighbor list index of compute neighbor list - - The compute instance requesting the neighbor list is uniquely - identified by the compute ID. In case the compute has requested - multiple neighbor lists, those are uniquely identified by a request - ID > 0 as set by the compute. Otherwise the request ID is 0 (the - default). - - :param computeid: name of compute - :type computeid: string - :param reqid: index of neighbor list request, in case there are more than one request, defaults to 0 - :type reqid: int, optional - :return: neighbor list index if found, otherwise -1 - :rtype: int - - """ - computeid = computeid.encode() - idx = self.lib.lammps_find_compute_neighlist(self.lmp, computeid, reqid) - return idx diff --git a/python/lammps/data.py b/python/lammps/data.py deleted file mode 100644 index 731a8c514a..0000000000 --- a/python/lammps/data.py +++ /dev/null @@ -1,92 +0,0 @@ -# ---------------------------------------------------------------------- -# LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator -# https://www.lammps.org/ Sandia National Laboratories -# Steve Plimpton, sjplimp@sandia.gov -# -# Copyright (2003) Sandia Corporation. Under the terms of Contract -# DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains -# certain rights in this software. This software is distributed under -# the GNU General Public License. -# -# See the README file in the top-level LAMMPS directory. -# ------------------------------------------------------------------------- - -################################################################################ -# LAMMPS data structures -# Written by Richard Berger -################################################################################ - -class NeighList(object): - """This is a wrapper class that exposes the contents of a neighbor list. - - It can be used like a regular Python list. Each element is a tuple of: - - * the atom local index - * its number of neighbors - * and a pointer to an c_int array containing local atom indices of its - neighbors - - Internally it uses the lower-level LAMMPS C-library interface. - - :param lmp: reference to instance of :py:class:`lammps` - :type lmp: lammps - :param idx: neighbor list index - :type idx: int - """ - def __init__(self, lmp, idx): - self.lmp = lmp - self.idx = idx - - def __str__(self): - return "Neighbor List ({} atoms)".format(self.size) - - def __repr__(self): - return self.__str__() - - @property - def size(self): - """ - :return: number of elements in neighbor list - """ - return self.lmp.get_neighlist_size(self.idx) - - def get(self, element): - """ - Access a specific neighbor list entry. "element" must be a number from 0 to the size-1 of the list - - :return: tuple with atom local index, number of neighbors and ctypes pointer to neighbor's local atom indices - :rtype: (int, int, ctypes.POINTER(c_int)) - """ - iatom, numneigh, neighbors = self.lmp.get_neighlist_element_neighbors(self.idx, element) - return iatom, numneigh, neighbors - - # the methods below implement the iterator interface, so NeighList can be used like a regular Python list - - def __getitem__(self, element): - return self.get(element) - - def __len__(self): - return self.size - - def __iter__(self): - inum = self.size - - for ii in range(inum): - yield self.get(ii) - - def find(self, iatom): - """ - Find the neighbor list for a specific (local) atom iatom. - If there is no list for iatom, (-1, None) is returned. - - :return: tuple with number of neighbors and ctypes pointer to neighbor's local atom indices - :rtype: (int, ctypes.POINTER(c_int)) - """ - - inum = self.size - for ii in range(inum): - idx, numneigh, neighbors = self.get(ii) - if idx == iatom: - return numneigh, neighbors - - return -1, None diff --git a/python/lammps/formats.py b/python/lammps/formats.py deleted file mode 100644 index b7c267466f..0000000000 --- a/python/lammps/formats.py +++ /dev/null @@ -1,227 +0,0 @@ -# ---------------------------------------------------------------------- -# LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator -# https://www.lammps.org/ Sandia National Laboratories -# Steve Plimpton, sjplimp@sandia.gov -# -# Copyright (2003) Sandia Corporation. Under the terms of Contract -# DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains -# certain rights in this software. This software is distributed under -# the GNU General Public License. -# -# See the README file in the top-level LAMMPS directory. -# ------------------------------------------------------------------------- - -################################################################################ -# LAMMPS output formats -# Written by Richard Berger -# and Axel Kohlmeyer -################################################################################ - -import re - -has_yaml = False -try: - import yaml - has_yaml = True - try: - from yaml import CSafeLoader as Loader - except ImportError: - from yaml import SafeLoader as Loader -except ImportError: - # ignore here, raise an exception when trying to parse yaml instead - pass - -class LogFile: - """Reads LAMMPS log files and extracts the thermo information - - It supports the line, multi, and yaml thermo output styles. - - :param filename: path to log file - :type filename: str - - :ivar runs: List of LAMMPS runs in log file. Each run is a dictionary with - thermo fields as keys, storing the values over time - :ivar errors: List of error lines in log file - """ - - STYLE_DEFAULT = 0 - STYLE_MULTI = 1 - STYLE_YAML = 2 - - def __init__(self, filename): - alpha = re.compile(r'[a-df-zA-DF-Z]') # except e or E for floating-point numbers - kvpairs = re.compile(r'([a-zA-Z_0-9]+)\s+=\s*([0-9\.eE\-]+)') - style = LogFile.STYLE_DEFAULT - yamllog = "" - self.runs = [] - self.errors = [] - with open(filename, 'rt') as f: - in_thermo = False - in_data_section = False - for line in f: - if "ERROR" in line or "exited on signal" in line: - self.errors.append(line) - - elif re.match(r'^ *Step ', line): - in_thermo = True - in_data_section = True - keys = line.split() - current_run = {} - for k in keys: - current_run[k] = [] - - elif re.match(r'^(keywords:.*$|data:$|---$| - \[.*\]$)', line): - if not has_yaml: - raise Exception('Cannot process YAML format logs without the PyYAML Python module') - style = LogFile.STYLE_YAML - yamllog += line; - current_run = {} - - elif re.match(r'^\.\.\.$', line): - thermo = yaml.load(yamllog, Loader=Loader) - for k in thermo['keywords']: - current_run[k] = [] - for step in thermo['data']: - icol = 0 - for k in thermo['keywords']: - current_run[k].append(step[icol]) - icol += 1 - self.runs.append(current_run) - yamllog = "" - - elif re.match(r'^------* Step ', line): - if not in_thermo: - current_run = {'Step': [], 'CPU': []} - in_thermo = True - in_data_section = True - style = LogFile.STYLE_MULTI - str_step, str_cpu = line.strip('-\n').split('-----') - step = float(str_step.split()[1]) - cpu = float(str_cpu.split('=')[1].split()[0]) - current_run["Step"].append(step) - current_run["CPU"].append(cpu) - - elif line.startswith('Loop time of'): - in_thermo = False - if style != LogFile.STYLE_YAML: - self.runs.append(current_run) - - elif in_thermo and in_data_section: - if style == LogFile.STYLE_DEFAULT: - if alpha.search(line): - continue - for k, v in zip(keys, map(float, line.split())): - current_run[k].append(v) - - elif style == LogFile.STYLE_MULTI: - if '=' not in line: - in_data_section = False - continue - for k,v in kvpairs.findall(line): - if k not in current_run: - current_run[k] = [float(v)] - else: - current_run[k].append(float(v)) - -class AvgChunkFile: - """Reads files generated by fix ave/chunk - - :param filename: path to ave/chunk file - :type filename: str - - :ivar timesteps: List of timesteps stored in file - :ivar total_count: total count over time - :ivar chunks: List of chunks. Each chunk is a dictionary containing its ID, the coordinates, and the averaged quantities - """ - def __init__(self, filename): - with open(filename, 'rt') as f: - timestep = None - chunks_read = 0 - - self.timesteps = [] - self.total_count = [] - self.chunks = [] - - for lineno, line in enumerate(f): - if lineno == 0: - if not line.startswith("# Chunk-averaged data for fix"): - raise Exception("Chunk data reader only supports default avg/chunk headers!") - parts = line.split() - self.fix_name = parts[5] - self.group_name = parts[8] - continue - elif lineno == 1: - if not line.startswith("# Timestep Number-of-chunks Total-count"): - raise Exception("Chunk data reader only supports default avg/chunk headers!") - continue - elif lineno == 2: - if not line.startswith("#"): - raise Exception("Chunk data reader only supports default avg/chunk headers!") - columns = line.split()[1:] - ndim = line.count("Coord") - compress = 'OrigID' in line - if ndim > 0: - coord_start = columns.index("Coord1") - coord_end = columns.index("Coord%d" % ndim) - ncount_start = coord_end + 1 - data_start = ncount_start + 1 - else: - coord_start = None - coord_end = None - ncount_start = 2 - data_start = 3 - continue - - parts = line.split() - - if timestep is None: - timestep = int(parts[0]) - num_chunks = int(parts[1]) - total_count = float(parts[2]) - - self.timesteps.append(timestep) - self.total_count.append(total_count) - - for i in range(num_chunks): - self.chunks.append({ - 'coord' : [], - 'ncount' : [] - }) - elif chunks_read < num_chunks: - chunk = int(parts[0]) - ncount = float(parts[ncount_start]) - - if compress: - chunk_id = int(parts[1]) - else: - chunk_id = chunk - - current = self.chunks[chunk_id - 1] - current['id'] = chunk_id - current['ncount'].append(ncount) - - if ndim > 0: - coord = tuple(map(float, parts[coord_start:coord_end+1])) - current['coord'].append(coord) - - for i, data_column in list(enumerate(columns))[data_start:]: - value = float(parts[i]) - - if data_column in current: - current[data_column].append(value) - else: - current[data_column] = [value] - - chunks_read += 1 - assert chunk == chunks_read - else: - # do not support changing number of chunks - if not (num_chunks == int(parts[1])): - raise Exception("Currently, changing numbers of chunks are not supported.") - - timestep = int(parts[0]) - total_count = float(parts[2]) - chunks_read = 0 - - self.timesteps.append(timestep) - self.total_count.append(total_count) diff --git a/python/lammps/mliap/__init__.py b/python/lammps/mliap/__init__.py deleted file mode 100644 index 57fe97d803..0000000000 --- a/python/lammps/mliap/__init__.py +++ /dev/null @@ -1,20 +0,0 @@ - -# Check compatiblity of this build with the python shared library. -# If this fails, lammps will segfault because its library will -# try to improperly start up a new interpreter. -import sysconfig -import ctypes -library = sysconfig.get_config_vars('INSTSONAME')[0] -try: - pylib = ctypes.CDLL(library) -except OSError as e: - if pylib.endswith(".a"): - pylib.strip(".a") + ".so" - pylib = ctypes.CDLL(library) - else: - raise e -if not pylib.Py_IsInitialized(): - raise RuntimeError("This interpreter is not compatible with python-based mliap for LAMMPS.") -del sysconfig, ctypes, library, pylib - -from .loader import load_model, activate_mliappy diff --git a/python/lammps/mliap/loader.py b/python/lammps/mliap/loader.py deleted file mode 100644 index dff791bfc1..0000000000 --- a/python/lammps/mliap/loader.py +++ /dev/null @@ -1,52 +0,0 @@ -# ---------------------------------------------------------------------- -# LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator -# https://www.lammps.org/ Sandia National Laboratories -# Steve Plimpton, sjplimp@sandia.gov -# -# Copyright (2003) Sandia Corporation. Under the terms of Contract -# DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains -# certain rights in this software. This software is distributed under -# the GNU General Public License. -# -# See the README file in the top-level LAMMPS directory. -# ------------------------------------------------------------------------- - -# ---------------------------------------------------------------------- -# Contributing author: Nicholas Lubbers (LANL) -# ------------------------------------------------------------------------- - - -import sys -import importlib.util -import importlib.machinery - -def activate_mliappy(lmp): - try: - # Begin Importlib magic to find the embedded python module - # This is needed because the filename for liblammps does not - # match the spec for normal python modules, wherein - # file names match with PyInit function names. - # Also, python normally doesn't look for extensions besides '.so' - # We fix both of these problems by providing an explict - # path to the extension module 'mliap_model_python_couple' in - - path = lmp.lib._name - loader = importlib.machinery.ExtensionFileLoader('mliap_model_python_couple', path) - spec = importlib.util.spec_from_loader('mliap_model_python_couple', loader) - module = importlib.util.module_from_spec(spec) - sys.modules['mliap_model_python_couple'] = module - spec.loader.exec_module(module) - # End Importlib magic to find the embedded python module - - except Exception as ee: - raise ImportError("Could not load ML-IAP python coupling module.") from ee - -def load_model(model): - try: - import mliap_model_python_couple - except ImportError as ie: - raise ImportError("ML-IAP python module must be activated before loading\n" - "the pair style. Call lammps.mliap.activate_mliappy(lmp)." - ) from ie - mliap_model_python_couple.load_from_python(model) - diff --git a/python/lammps/mliap/pytorch.py b/python/lammps/mliap/pytorch.py deleted file mode 100644 index 9aa2da80f4..0000000000 --- a/python/lammps/mliap/pytorch.py +++ /dev/null @@ -1,326 +0,0 @@ -# ---------------------------------------------------------------------- -# LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator -# https://www.lammps.org/ Sandia National Laboratories -# Steve Plimpton, sjplimp@sandia.gov -# -# Copyright (2003) Sandia Corporation. Under the terms of Contract -# DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains -# certain rights in this software. This software is distributed under -# the GNU General Public License. -# -# See the README file in the top-level LAMMPS directory. -# ------------------------------------------------------------------------- - -# ---------------------------------------------------------------------- -# Contributing author: Nicholas Lubbers (LANL) -# ------------------------------------------------------------------------- - -import numpy as np -import torch - -def calc_n_params(model): - """ - Returns the sum of two decimal numbers in binary digits. - - Parameters: - model (torch.nn.Module): Network model that maps descriptors to a per atom attribute - - Returns: - n_params (int): Number of NN model parameters - """ - return sum(p.nelement() for p in model.parameters()) - -class TorchWrapper(torch.nn.Module): - """ - A class to wrap Modules to ensure lammps mliap compatability. - - ... - - Attributes - ---------- - model : torch.nn.Module - Network model that maps descriptors to a per atom attribute - - device : torch.nn.Module (None) - Accelerator device - - dtype : torch.dtype (torch.float64) - Dtype to use on device - - n_params : torch.nn.Module (None) - Number of NN model parameters - - n_descriptors : int - Max number of per atom descriptors - - n_elements : int - Max number of elements - - - Methods - ------- - forward(descriptors, elems): - Feeds descriptors to network model to produce per atom energies and forces. - """ - - def __init__(self, model, n_descriptors, n_elements, n_params=None, device=None, dtype=torch.float64): - """ - Constructs all the necessary attributes for the network module. - - Parameters - ---------- - model : torch.nn.Module - Network model that maps descriptors to a per atom attribute - - n_descriptors : int - Max number of per atom descriptors - - n_elements : int - Max number of elements - - n_params : torch.nn.Module (None) - Number of NN model parameters - - device : torch.nn.Module (None) - Accelerator device - - dtype : torch.dtype (torch.float64) - Dtype to use on device - """ - - super().__init__() - - self.model = model - self.device = device - self.dtype = dtype - - # Put model on device and convert to dtype - self.to(self.dtype) - self.to(self.device) - - if n_params is None: - n_params = calc_n_params(model) - - self.n_params = n_params - self.n_descriptors = n_descriptors - self.n_elements = n_elements - - def forward(self, elems, descriptors, beta, energy): - """ - Takes element types and descriptors calculated via lammps and - calculates the per atom energies and forces. - - Parameters - ---------- - elems : numpy.array - Per atom element types - - descriptors : numpy.array - Per atom descriptors - - beta : numpy.array - Expired beta array to be filled with new betas - - energy : numpy.array - Expired per atom energy array to be filled with new per atom energy - (Note: This is a pointer to the lammps per atom energies) - - - Returns - ------- - None - """ - - descriptors = torch.from_numpy(descriptors).to(dtype=self.dtype, device=self.device).requires_grad_(True) - elems = torch.from_numpy(elems).to(dtype=torch.long, device=self.device) - 1 - - with torch.autograd.enable_grad(): - - energy_nn = self.model(descriptors, elems) - if energy_nn.ndim > 1: - energy_nn = energy_nn.flatten() - - beta_nn = torch.autograd.grad(energy_nn.sum(), descriptors)[0] - - beta[:] = beta_nn.detach().cpu().numpy().astype(np.float64) - energy[:] = energy_nn.detach().cpu().numpy().astype(np.float64) - - -class IgnoreElems(torch.nn.Module): - """ - A class to represent a NN model agnostic of element typing. - - ... - - Attributes - ---------- - subnet : torch.nn.Module - Network model that maps descriptors to a per atom attribute - - Methods - ------- - forward(descriptors, elems): - Feeds descriptors to network model - """ - - def __init__(self, subnet): - """ - Constructs all the necessary attributes for the network module. - - Parameters - ---------- - subnet : torch.nn.Module - Network model that maps descriptors to a per atom attribute - """ - - super().__init__() - self.subnet = subnet - - def forward(self, descriptors, elems): - """ - Feeds descriptors to network model - - Parameters - ---------- - descriptors : torch.tensor - Per atom descriptors - - elems : torch.tensor - Per atom element types - - Returns - ------- - self.subnet(descriptors) : torch.tensor - Per atom attribute computed by the network model - """ - - return self.subnet(descriptors) - - -class UnpackElems(torch.nn.Module): - """ - A class to represent a NN model pseudo-agnostic of element typing for - systems with multiple element typings. - - ... - - Attributes - ---------- - subnet : torch.nn.Module - Network model that maps descriptors to a per atom attribute - - n_types : int - Number of atom types used in training the NN model. - - Methods - ------- - forward(descriptors, elems): - Feeds descriptors to network model after adding zeros into - descriptor columns relating to different atom types - """ - - def __init__(self, subnet, n_types): - """ - Constructs all the necessary attributes for the network module. - - Parameters - ---------- - subnet : torch.nn.Module - Network model that maps descriptors to a per atom attribute. - - n_types : int - Number of atom types used in training the NN model. - """ - super().__init__() - self.subnet = subnet - self.n_types = n_types - - def forward(self, descriptors, elems): - """ - Feeds descriptors to network model after adding zeros into - descriptor columns relating to different atom types - - Parameters - ---------- - descriptors : torch.tensor - Per atom descriptors - - elems : torch.tensor - Per atom element types - - Returns - ------- - self.subnet(descriptors) : torch.tensor - Per atom attribute computed by the network model - """ - - unpacked_descriptors = torch.zeros(elems.shape[0], self.n_types, descriptors.shape[1], dtype=torch.float64) - for i, ind in enumerate(elems): - unpacked_descriptors[i, ind, :] = descriptors[i] - return self.subnet(torch.reshape(unpacked_descriptors, (elems.shape[0], -1)), elems) - - -class ElemwiseModels(torch.nn.Module): - """ - A class to represent a NN model dependent on element typing. - - ... - - Attributes - ---------- - subnets : list of torch.nn.Modules - Per element type network models that maps per element type - descriptors to a per atom attribute. - - n_types : int - Number of atom types used in training the NN model. - - Methods - ------- - forward(descriptors, elems): - Feeds descriptors to network model after adding zeros into - descriptor columns relating to different atom types - """ - - def __init__(self, subnets, n_types): - """ - Constructs all the necessary attributes for the network module. - - Parameters - ---------- - subnets : list of torch.nn.Modules - Per element type network models that maps per element - type descriptors to a per atom attribute. - - n_types : int - Number of atom types used in training the NN model. - """ - - super().__init__() - self.subnets = subnets - self.n_types = n_types - - def forward(self, descriptors, elems): - """ - Feeds descriptors to network model after adding zeros into - descriptor columns relating to different atom types - - Parameters - ---------- - descriptors : torch.tensor - Per atom descriptors - - elems : torch.tensor - Per atom element types - - Returns - ------- - self.subnets(descriptors) : torch.tensor - Per atom attribute computed by the network model - """ - - per_atom_attributes = torch.zeros(elems.size[0]) - given_elems, elem_indices = torch.unique(elems, return_inverse=True) - for i, elem in enumerate(given_elems): - per_atom_attribute[elem_indices == i] = self.subnets[elem](descriptors[elem_indices == i]) - return per_atom_attributes diff --git a/python/lammps/numpy_wrapper.py b/python/lammps/numpy_wrapper.py deleted file mode 100644 index ce0cb35e47..0000000000 --- a/python/lammps/numpy_wrapper.py +++ /dev/null @@ -1,483 +0,0 @@ -# ---------------------------------------------------------------------- -# LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator -# https://www.lammps.org/ Sandia National Laboratories -# Steve Plimpton, sjplimp@sandia.gov -# -# Copyright (2003) Sandia Corporation. Under the terms of Contract -# DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains -# certain rights in this software. This software is distributed under -# the GNU General Public License. -# -# See the README file in the top-level LAMMPS directory. -# ------------------------------------------------------------------------- - -################################################################################ -# NumPy additions -# Written by Richard Berger -################################################################################ - -import warnings -from ctypes import POINTER, c_void_p, c_char_p, c_double, c_int, c_int32, c_int64, cast - - -from .constants import * # lgtm [py/polluting-import] -from .data import NeighList - - -class numpy_wrapper: - """lammps API NumPy Wrapper - - This is a wrapper class that provides additional methods on top of an - existing :py:class:`lammps` instance. The methods transform raw ctypes - pointers into NumPy arrays, which give direct access to the - original data while protecting against out-of-bounds accesses. - - There is no need to explicitly instantiate this class. Each instance - of :py:class:`lammps` has a :py:attr:`numpy ` property - that returns an instance. - - :param lmp: instance of the :py:class:`lammps` class - :type lmp: lammps - """ - def __init__(self, lmp): - self.lmp = lmp - - # ------------------------------------------------------------------------- - - def _ctype_to_numpy_int(self, ctype_int): - import numpy as np - if ctype_int == c_int32: - return np.int32 - elif ctype_int == c_int64: - return np.int64 - return np.intc - - # ------------------------------------------------------------------------- - - def extract_atom(self, name, dtype=LAMMPS_AUTODETECT, nelem=LAMMPS_AUTODETECT, dim=LAMMPS_AUTODETECT): - """Retrieve per-atom properties from LAMMPS as NumPy arrays - - This is a wrapper around the :py:meth:`lammps.extract_atom()` method. - It behaves the same as the original method, but returns NumPy arrays - instead of ``ctypes`` pointers. - - .. note:: - - While the returned arrays of per-atom data are dimensioned - for the range [0:nmax] - as is the underlying storage - - the data is usually only valid for the range of [0:nlocal], - unless the property of interest is also updated for ghost - atoms. In some cases, this depends on a LAMMPS setting, see - for example :doc:`comm_modify vel yes `. - - :param name: name of the property - :type name: string - :param dtype: type of the returned data (see :ref:`py_datatype_constants`) - :type dtype: int, optional - :param nelem: number of elements in array - :type nelem: int, optional - :param dim: dimension of each element - :type dim: int, optional - :return: requested data as NumPy array with direct access to C data or None - :rtype: numpy.array or NoneType - """ - if dtype == LAMMPS_AUTODETECT: - dtype = self.lmp.extract_atom_datatype(name) - - if nelem == LAMMPS_AUTODETECT: - if name == "mass": - nelem = self.lmp.extract_global("ntypes") + 1 - else: - nelem = self.lmp.extract_global("nlocal") - if dim == LAMMPS_AUTODETECT: - if dtype in (LAMMPS_INT_2D, LAMMPS_DOUBLE_2D, LAMMPS_INT64_2D): - # TODO add other fields - if name in ("x", "v", "f", "x0","omega", "angmom", "torque", "csforce", "vforce", "vest"): - dim = 3 - elif name == "smd_data_9": - dim = 9 - elif name == "smd_stress": - dim = 6 - else: - dim = 2 - else: - dim = 1 - - raw_ptr = self.lmp.extract_atom(name, dtype) - - if dtype in (LAMMPS_DOUBLE, LAMMPS_DOUBLE_2D): - return self.darray(raw_ptr, nelem, dim) - elif dtype in (LAMMPS_INT, LAMMPS_INT_2D): - return self.iarray(c_int32, raw_ptr, nelem, dim) - elif dtype in (LAMMPS_INT64, LAMMPS_INT64_2D): - return self.iarray(c_int64, raw_ptr, nelem, dim) - return raw_ptr - - # ------------------------------------------------------------------------- - - def extract_atom_iarray(self, name, nelem, dim=1): - warnings.warn("deprecated, use extract_atom instead", DeprecationWarning) - - if name in ['id', 'molecule']: - c_int_type = self.lmp.c_tagint - elif name in ['image']: - c_int_type = self.lmp.c_imageint - else: - c_int_type = c_int - - if dim == 1: - raw_ptr = self.lmp.extract_atom(name, LAMMPS_INT) - else: - raw_ptr = self.lmp.extract_atom(name, LAMMPS_INT_2D) - - return self.iarray(c_int_type, raw_ptr, nelem, dim) - - # ------------------------------------------------------------------------- - - def extract_atom_darray(self, name, nelem, dim=1): - warnings.warn("deprecated, use extract_atom instead", DeprecationWarning) - - if dim == 1: - raw_ptr = self.lmp.extract_atom(name, LAMMPS_DOUBLE) - else: - raw_ptr = self.lmp.extract_atom(name, LAMMPS_DOUBLE_2D) - - return self.darray(raw_ptr, nelem, dim) - - # ------------------------------------------------------------------------- - - def extract_compute(self, cid, cstyle, ctype): - """Retrieve data from a LAMMPS compute - - This is a wrapper around the - :py:meth:`lammps.extract_compute() ` method. - It behaves the same as the original method, but returns NumPy arrays - instead of ``ctypes`` pointers. - - :param cid: compute ID - :type cid: string - :param cstyle: style of the data retrieve (global, atom, or local), see :ref:`py_style_constants` - :type cstyle: int - :param ctype: type of the returned data (scalar, vector, or array), see :ref:`py_type_constants` - :type ctype: int - :return: requested data either as float, as NumPy array with direct access to C data, or None - :rtype: float, numpy.array, or NoneType - """ - value = self.lmp.extract_compute(cid, cstyle, ctype) - - if cstyle == LMP_STYLE_GLOBAL: - if ctype == LMP_TYPE_VECTOR: - nrows = self.lmp.extract_compute(cid, cstyle, LMP_SIZE_VECTOR) - return self.darray(value, nrows) - elif ctype == LMP_TYPE_ARRAY: - nrows = self.lmp.extract_compute(cid, cstyle, LMP_SIZE_ROWS) - ncols = self.lmp.extract_compute(cid, cstyle, LMP_SIZE_COLS) - return self.darray(value, nrows, ncols) - elif cstyle == LMP_STYLE_LOCAL: - nrows = self.lmp.extract_compute(cid, cstyle, LMP_SIZE_ROWS) - ncols = self.lmp.extract_compute(cid, cstyle, LMP_SIZE_COLS) - if ncols == 0: - return self.darray(value, nrows) - else: - return self.darray(value, nrows, ncols) - elif cstyle == LMP_STYLE_ATOM: - if ctype == LMP_TYPE_VECTOR: - nlocal = self.lmp.extract_global("nlocal") - return self.darray(value, nlocal) - elif ctype == LMP_TYPE_ARRAY: - nlocal = self.lmp.extract_global("nlocal") - ncols = self.lmp.extract_compute(cid, cstyle, LMP_SIZE_COLS) - return self.darray(value, nlocal, ncols) - return value - - # ------------------------------------------------------------------------- - - def extract_fix(self, fid, fstyle, ftype, nrow=0, ncol=0): - """Retrieve data from a LAMMPS fix - - This is a wrapper around the :py:meth:`lammps.extract_fix() ` method. - It behaves the same as the original method, but returns NumPy arrays - instead of ``ctypes`` pointers. - - :param fid: fix ID - :type fid: string - :param fstyle: style of the data retrieve (global, atom, or local), see :ref:`py_style_constants` - :type fstyle: int - :param ftype: type or size of the returned data (scalar, vector, or array), see :ref:`py_type_constants` - :type ftype: int - :param nrow: index of global vector element or row index of global array element - :type nrow: int - :param ncol: column index of global array element - :type ncol: int - :return: requested data - :rtype: integer or double value, pointer to 1d or 2d double array or None - - """ - value = self.lmp.extract_fix(fid, fstyle, ftype, nrow, ncol) - if fstyle == LMP_STYLE_ATOM: - if ftype == LMP_TYPE_VECTOR: - nlocal = self.lmp.extract_global("nlocal") - return self.darray(value, nlocal) - elif ftype == LMP_TYPE_ARRAY: - nlocal = self.lmp.extract_global("nlocal") - ncols = self.lmp.extract_fix(fid, fstyle, LMP_SIZE_COLS, 0, 0) - return self.darray(value, nlocal, ncols) - elif fstyle == LMP_STYLE_LOCAL: - if ftype == LMP_TYPE_VECTOR: - nrows = self.lmp.extract_fix(fid, fstyle, LMP_SIZE_ROWS, 0, 0) - return self.darray(value, nrows) - elif ftype == LMP_TYPE_ARRAY: - nrows = self.lmp.extract_fix(fid, fstyle, LMP_SIZE_ROWS, 0, 0) - ncols = self.lmp.extract_fix(fid, fstyle, LMP_SIZE_COLS, 0, 0) - return self.darray(value, nrows, ncols) - return value - - # ------------------------------------------------------------------------- - - def extract_variable(self, name, group=None, vartype=LMP_VAR_EQUAL): - """ Evaluate a LAMMPS variable and return its data - - This function is a wrapper around the function - :py:meth:`lammps.extract_variable() ` - method. It behaves the same as the original method, but returns NumPy arrays - instead of ``ctypes`` pointers. - - :param name: name of the variable to execute - :type name: string - :param group: name of group for atom-style variable (ignored for equal-style variables) - :type group: string - :param vartype: type of variable, see :ref:`py_vartype_constants` - :type vartype: int - :return: the requested data or None - :rtype: c_double, numpy.array, or NoneType - """ - import numpy as np - value = self.lmp.extract_variable(name, group, vartype) - if vartype == LMP_VAR_ATOM: - return np.ctypeslib.as_array(value) - return value - - # ------------------------------------------------------------------------- - - def gather_bonds(self): - """Retrieve global list of bonds as NumPy array - - This is a wrapper around :py:meth:`lammps.gather_bonds() ` - It behaves the same as the original method, but returns a NumPy array instead - of a ``ctypes`` list. - - .. versionadded:: 28Jul2021 - - :return: the requested data as a 2d-integer numpy array - :rtype: numpy.array(nbonds,3) - """ - import numpy as np - nbonds, value = self.lmp.gather_bonds() - return np.ctypeslib.as_array(value).reshape(nbonds,3) - - # ------------------------------------------------------------------------- - - def fix_external_get_force(self, fix_id): - """Get access to the array with per-atom forces of a fix external instance with a given fix ID. - - This function is a wrapper around the - :py:meth:`lammps.fix_external_get_force() ` - method. It behaves the same as the original method, but returns a NumPy array instead - of a ``ctypes`` pointer. - - .. versionchanged:: 28Jul2021 - - :param fix_id: Fix-ID of a fix external instance - :type: string - :return: requested data - :rtype: numpy.array - """ - import numpy as np - nlocal = self.lmp.extract_setting('nlocal') - value = self.lmp.fix_external_get_force(fix_id) - return self.darray(value,nlocal,3) - - # ------------------------------------------------------------------------- - - def fix_external_set_energy_peratom(self, fix_id, eatom): - """Set the per-atom energy contribution for a fix external instance with the given ID. - - This function is an alternative to - :py:meth:`lammps.fix_external_set_energy_peratom() ` - method. It behaves the same as the original method, but accepts a NumPy array - instead of a list as argument. - - .. versionadded:: 28Jul2021 - - :param fix_id: Fix-ID of a fix external instance - :type: string - :param eatom: per-atom potential energy - :type: numpy.array - """ - import numpy as np - nlocal = self.lmp.extract_setting('nlocal') - if len(eatom) < nlocal: - raise Exception('per-atom energy dimension must be at least nlocal') - - c_double_p = POINTER(c_double) - value = eatom.astype(np.double) - return self.lmp.lib.lammps_fix_external_set_energy_peratom(self.lmp.lmp, fix_id.encode(), - value.ctypes.data_as(c_double_p)) - - # ------------------------------------------------------------------------- - - def fix_external_set_virial_peratom(self, fix_id, vatom): - """Set the per-atom virial contribution for a fix external instance with the given ID. - - This function is an alternative to - :py:meth:`lammps.fix_external_set_virial_peratom() ` - method. It behaves the same as the original method, but accepts a NumPy array - instead of a list as argument. - - .. versionadded:: 28Jul2021 - - :param fix_id: Fix-ID of a fix external instance - :type: string - :param eatom: per-atom potential energy - :type: numpy.array - """ - import numpy as np - nlocal = self.lmp.extract_setting('nlocal') - if len(vatom) < nlocal: - raise Exception('per-atom virial first dimension must be at least nlocal') - if len(vatom[0]) != 6: - raise Exception('per-atom virial second dimension must be 6') - - c_double_pp = np.ctypeslib.ndpointer(dtype=np.uintp, ndim=1, flags='C') - - # recast numpy array to be compatible with library interface - value = (vatom.__array_interface__['data'][0] - + np.arange(vatom.shape[0])*vatom.strides[0]).astype(np.uintp) - - # change prototype to our custom type - self.lmp.lib.lammps_fix_external_set_virial_peratom.argtypes = [ c_void_p, c_char_p, c_double_pp ] - - self.lmp.lib.lammps_fix_external_set_virial_peratom(self.lmp.lmp, fix_id.encode(), value) - - # ------------------------------------------------------------------------- - - def get_neighlist(self, idx): - """Returns an instance of :class:`NumPyNeighList` which wraps access to the neighbor list with the given index - - :param idx: index of neighbor list - :type idx: int - :return: an instance of :class:`NumPyNeighList` wrapping access to neighbor list data - :rtype: NumPyNeighList - """ - if idx < 0: - return None - return NumPyNeighList(self.lmp, idx) - - # ------------------------------------------------------------------------- - - def get_neighlist_element_neighbors(self, idx, element): - """Return data of neighbor list entry - - This function is a wrapper around the function - :py:meth:`lammps.get_neighlist_element_neighbors() ` - method. It behaves the same as the original method, but returns a NumPy array containing the neighbors - instead of a ``ctypes`` pointer. - - :param element: neighbor list index - :type element: int - :param element: neighbor list element index - :type element: int - :return: tuple with atom local index and numpy array of neighbor local atom indices - :rtype: (int, numpy.array) - """ - iatom, numneigh, c_neighbors = self.lmp.get_neighlist_element_neighbors(idx, element) - neighbors = self.iarray(c_int, c_neighbors, numneigh, 1) - return iatom, neighbors - - # ------------------------------------------------------------------------- - - def iarray(self, c_int_type, raw_ptr, nelem, dim=1): - if raw_ptr is None: - return None - - import numpy as np - np_int_type = self._ctype_to_numpy_int(c_int_type) - - if dim == 1: - ptr = cast(raw_ptr, POINTER(c_int_type * nelem)) - else: - ptr = cast(raw_ptr[0], POINTER(c_int_type * nelem * dim)) - - a = np.frombuffer(ptr.contents, dtype=np_int_type) - - if dim > 1: - a.shape = (nelem, dim) - else: - a.shape = (nelem) - return a - - # ------------------------------------------------------------------------- - - def darray(self, raw_ptr, nelem, dim=1): - if raw_ptr is None: - return None - - import numpy as np - - if dim == 1: - ptr = cast(raw_ptr, POINTER(c_double * nelem)) - else: - ptr = cast(raw_ptr[0], POINTER(c_double * nelem * dim)) - - a = np.frombuffer(ptr.contents) - - if dim > 1: - a.shape = (nelem, dim) - else: - a.shape = (nelem) - return a - -# ------------------------------------------------------------------------- - -class NumPyNeighList(NeighList): - """This is a wrapper class that exposes the contents of a neighbor list. - - It can be used like a regular Python list. Each element is a tuple of: - - * the atom local index - * a NumPy array containing the local atom indices of its neighbors - - Internally it uses the lower-level LAMMPS C-library interface. - - :param lmp: reference to instance of :py:class:`lammps` - :type lmp: lammps - :param idx: neighbor list index - :type idx: int - """ - def __init__(self, lmp, idx): - super(NumPyNeighList, self).__init__(lmp, idx) - - def get(self, element): - """ - Access a specific neighbor list entry. "element" must be a number from 0 to the size-1 of the list - - :return: tuple with atom local index, numpy array of neighbor local atom indices - :rtype: (int, numpy.array) - """ - iatom, neighbors = self.lmp.numpy.get_neighlist_element_neighbors(self.idx, element) - return iatom, neighbors - - def find(self, iatom): - """ - Find the neighbor list for a specific (local) atom iatom. - If there is no list for iatom, None is returned. - - :return: numpy array of neighbor local atom indices - :rtype: numpy.array or None - """ - inum = self.size - for ii in range(inum): - idx, neighbors = self.get(ii) - if idx == iatom: - return neighbors - return None diff --git a/python/lammps/pylammps.py b/python/lammps/pylammps.py deleted file mode 100644 index 1fe1f2452b..0000000000 --- a/python/lammps/pylammps.py +++ /dev/null @@ -1,990 +0,0 @@ -# ---------------------------------------------------------------------- -# LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator -# https://www.lammps.org/ Sandia National Laboratories -# Steve Plimpton, sjplimp@sandia.gov -# -# Copyright (2003) Sandia Corporation. Under the terms of Contract -# DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains -# certain rights in this software. This software is distributed under -# the GNU General Public License. -# -# See the README file in the top-level LAMMPS directory. -# ------------------------------------------------------------------------- - -################################################################################ -# Alternative Python Wrapper -# Written by Richard Berger -################################################################################ - -# for python2/3 compatibility - -from __future__ import print_function - -import io -import os -import re -import sys -import tempfile -from collections import namedtuple - -from .core import lammps - -# ------------------------------------------------------------------------- - -class OutputCapture(object): - """ Utility class to capture LAMMPS library output """ - def __init__(self): - self.stdout_fd = 1 - self.captured_output = "" - - def __enter__(self): - self.tmpfile = tempfile.TemporaryFile(mode='w+b') - - sys.stdout.flush() - - # make copy of original stdout - self.stdout_orig = os.dup(self.stdout_fd) - - # replace stdout and redirect to temp file - os.dup2(self.tmpfile.fileno(), self.stdout_fd) - return self - - def __exit__(self, exc_type, exc_value, traceback): - os.dup2(self.stdout_orig, self.stdout_fd) - os.close(self.stdout_orig) - self.tmpfile.close() - - @property - def output(self): - sys.stdout.flush() - self.tmpfile.flush() - self.tmpfile.seek(0, io.SEEK_SET) - self.captured_output = self.tmpfile.read().decode('utf-8') - return self.captured_output - -# ------------------------------------------------------------------------- - -class Variable(object): - def __init__(self, pylammps_instance, name, style, definition): - self._pylmp = pylammps_instance - self.name = name - self.style = style - self.definition = definition.split() - - @property - def value(self): - if self.style == 'atom': - return list(self._pylmp.lmp.extract_variable(self.name, "all", 1)) - else: - value = self._pylmp.lmp_print('"${%s}"' % self.name).strip() - try: - return float(value) - except ValueError: - return value - -# ------------------------------------------------------------------------- - -class AtomList(object): - """ - A dynamic list of atoms that returns either an :py:class:`Atom` or - :py:class:`Atom2D` instance for each atom. Instances are only allocated - when accessed. - - :ivar natoms: total number of atoms - :ivar dimensions: number of dimensions in system - """ - def __init__(self, pylammps_instance): - self._pylmp = pylammps_instance - self.natoms = self._pylmp.system.natoms - self.dimensions = self._pylmp.system.dimensions - self._loaded = {} - - def __getitem__(self, index): - """ - Return Atom with given local index - - :param index: Local index of atom - :type index: int - :rtype: Atom or Atom2D - """ - if index not in self._loaded: - if self.dimensions == 2: - atom = Atom2D(self._pylmp, index) - else: - atom = Atom(self._pylmp, index) - self._loaded[index] = atom - return self._loaded[index] - - def __len__(self): - return self.natoms - - -# ------------------------------------------------------------------------- - -class Atom(object): - """ - A wrapper class then represents a single atom inside of LAMMPS - - It provides access to properties of the atom and allows you to change some of them. - """ - def __init__(self, pylammps_instance, index): - self._pylmp = pylammps_instance - self.index = index - - def __dir__(self): - return [k for k in super().__dir__() if not k.startswith('_')] - - def get(self, name, index): - prop = self._pylmp.lmp.numpy.extract_atom(name) - if prop is not None: - return prop[index] - return None - - @property - def id(self): - """ - Return the atom ID - - :type: int - """ - return self.get("id", self.index) - - @property - def type(self): - """ - Return the atom type - - :type: int - """ - return self.get("type", self.index) - - @property - def mol(self): - """ - Return the atom molecule index - - :type: int - """ - return self.get("mol", self.index) - - @property - def mass(self): - """ - Return the atom mass - - :type: float - """ - return self.get("mass", self.index) - - @property - def radius(self): - """ - Return the particle radius - - :type: float - """ - return self.get("radius", self.index) - - @property - def position(self): - """ - :getter: Return position of atom - :setter: Set position of atom - :type: numpy.array (float, float, float) - """ - return self.get("x", self.index) - - @position.setter - def position(self, value): - current = self.position - current[:] = value - - @property - def velocity(self): - """ - :getter: Return velocity of atom - :setter: Set velocity of atom - :type: numpy.array (float, float, float) - """ - return self.get("v", self.index) - - @velocity.setter - def velocity(self, value): - current = self.velocity - current[:] = value - - @property - def force(self): - """ - Return the total force acting on the atom - - :type: numpy.array (float, float, float) - """ - return self.get("f", self.index) - - @force.setter - def force(self, value): - current = self.force - current[:] = value - - @property - def torque(self): - """ - Return the total torque acting on the atom - - :type: numpy.array (float, float, float) - """ - return self.get("torque", self.index) - - @force.setter - def torque(self, value): - current = self.torque - current[:] = value - - @property - def omega(self): - """ - Return the rotational velocity of the particle - - :type: numpy.array (float, float, float) - """ - return self.get("torque", self.index) - - @omega.setter - def omega(self, value): - current = self.torque - current[:] = value - - @property - def torque(self): - """ - Return the total torque acting on the particle - - :type: numpy.array (float, float, float) - """ - return self.get("torque", self.index) - - @torque.setter - def torque(self, value): - current = self.torque - current[:] = value - - @property - def angular_momentum(self): - """ - Return the angular momentum of the particle - - :type: numpy.array (float, float, float) - """ - return self.get("angmom", self.index) - - @angular_momentum.setter - def angular_momentum(self, value): - current = self.angular_momentum - current[:] = value - - @property - def charge(self): - """ - Return the atom charge - - :type: float - """ - return self.get("q", self.index) - -# ------------------------------------------------------------------------- - -class Atom2D(Atom): - """ - A wrapper class then represents a single 2D atom inside of LAMMPS - - Inherits all properties from the :py:class:`Atom` class, but returns 2D versions - of position, velocity, and force. - - It provides access to properties of the atom and allows you to change some of them. - """ - def __init__(self, pylammps_instance, index): - super(Atom2D, self).__init__(pylammps_instance, index) - - @property - def position(self): - """Access to coordinates of an atom - - :getter: Return position of atom - :setter: Set position of atom - :type: numpy.array (float, float) - """ - return super(Atom2D, self).position[0:2] - - @position.setter - def position(self, value): - current = self.position - current[:] = value - - @property - def velocity(self): - """Access to velocity of an atom - :getter: Return velocity of atom - :setter: Set velocity of atom - :type: numpy.array (float, float) - """ - return super(Atom2D, self).velocity[0:2] - - @velocity.setter - def velocity(self, value): - current = self.velocity - current[:] = value - - @property - def force(self): - """Access to force of an atom - :getter: Return force of atom - :setter: Set force of atom - :type: numpy.array (float, float) - """ - return super(Atom2D, self).force[0:2] - - @force.setter - def force(self, value): - current = self.force - current[:] = value - -# ------------------------------------------------------------------------- - -class variable_set: - def __init__(self, name, variable_dict): - self._name = name - array_pattern = re.compile(r"(?P.+)\[(?P[0-9]+)\]") - - for key, value in variable_dict.items(): - m = array_pattern.match(key) - if m: - g = m.groupdict() - varname = g['arr'] - idx = int(g['index']) - if varname not in self.__dict__: - self.__dict__[varname] = {} - self.__dict__[varname][idx] = value - else: - self.__dict__[key] = value - - def __str__(self): - return "{}({})".format(self._name, ','.join(["{}={}".format(k, self.__dict__[k]) for k in self.__dict__.keys() if not k.startswith('_')])) - - def __dir__(self): - return [k for k in self.__dict__.keys() if not k.startswith('_')] - - def __repr__(self): - return self.__str__() - -# ------------------------------------------------------------------------- - -def get_thermo_data(output): - """ traverse output of runs and extract thermo data columns """ - if isinstance(output, str): - lines = output.splitlines() - else: - lines = output - - runs = [] - columns = [] - in_run = False - current_run = {} - - for line in lines: - if line.startswith("Per MPI rank memory allocation"): - in_run = True - elif in_run and len(columns) == 0: - # first line after memory usage are column names - columns = line.split() - - current_run = {} - - for col in columns: - current_run[col] = [] - - elif line.startswith("Loop time of "): - in_run = False - columns = [] - thermo_data = variable_set('ThermoData', current_run) - r = {'thermo' : thermo_data } - runs.append(namedtuple('Run', list(r.keys()))(*list(r.values()))) - elif in_run and len(columns) > 0: - items = line.split() - # Convert thermo output and store it. - # It must have the same number of columns and - # all of them must be convertible to floats. - # Otherwise we ignore the line - if len(items) == len(columns): - try: - values = [float(x) for x in items] - for i, col in enumerate(columns): - current_run[col].append(values[i]) - except ValueError: - # cannot convert. must be a non-thermo output. ignore. - pass - - return runs - -# ------------------------------------------------------------------------- -# ------------------------------------------------------------------------- - -class PyLammps(object): - """ - This is a Python wrapper class around the lower-level - :py:class:`lammps` class, exposing a more Python-like, - object-oriented interface for prototyping system inside of IPython and - Jupyter notebooks. - - It either creates its own instance of :py:class:`lammps` or can be - initialized with an existing instance. The arguments are the same of the - lower-level interface. The original interface can still be accessed via - :py:attr:`PyLammps.lmp`. - - :param name: "machine" name of the shared LAMMPS library ("mpi" loads ``liblammps_mpi.so``, "" loads ``liblammps.so``) - :type name: string - :param cmdargs: list of command line arguments to be passed to the :cpp:func:`lammps_open` function. The executable name is automatically added. - :type cmdargs: list - :param ptr: pointer to a LAMMPS C++ class instance when called from an embedded Python interpreter. None means load symbols from shared library. - :type ptr: pointer - :param comm: MPI communicator (as provided by `mpi4py `_). ``None`` means use ``MPI_COMM_WORLD`` implicitly. - :type comm: MPI_Comm - :param verbose: print all LAMMPS output to stdout - :type verbose: bool - - :ivar lmp: instance of original LAMMPS Python interface - :vartype lmp: :py:class:`lammps` - - :ivar runs: list of completed runs, each storing the thermo output - :vartype run: list - """ - - def __init__(self, name="", cmdargs=None, ptr=None, comm=None, verbose=False): - self.has_echo = False - self.verbose = verbose - - if cmdargs: - if '-echo' in cmdargs: - idx = cmdargs.index('-echo') - # ensures that echo line is ignored during output capture - self.has_echo = idx+1 < len(cmdargs) and cmdargs[idx+1] in ('screen', 'both') - - if ptr: - if isinstance(ptr,PyLammps): - self.lmp = ptr.lmp - elif isinstance(ptr,lammps): - self.lmp = ptr - else: - self.lmp = lammps(name=name,cmdargs=cmdargs,ptr=ptr,comm=comm) - else: - self.lmp = lammps(name=name,cmdargs=cmdargs,ptr=None,comm=comm) - print("LAMMPS output is captured by PyLammps wrapper") - self._cmd_history = [] - self._enable_cmd_history = False - self.runs = [] - - def __enter__(self): - return self - - def __exit__(self, ex_type, ex_value, ex_traceback): - self.close() - - def __del__(self): - if self.lmp: self.lmp.close() - self.lmp = None - - def close(self): - """Explicitly delete a LAMMPS instance - - This is a wrapper around the :py:meth:`lammps.close` of the Python interface. - """ - if self.lmp: self.lmp.close() - self.lmp = None - - def version(self): - """Return a numerical representation of the LAMMPS version in use. - - This is a wrapper around the :py:meth:`lammps.version` function of the Python interface. - - :return: version number - :rtype: int - """ - return self.lmp.version() - - def file(self, file): - """Read LAMMPS commands from a file. - - This is a wrapper around the :py:meth:`lammps.file` function of the Python interface. - - :param path: Name of the file/path with LAMMPS commands - :type path: string - """ - self.lmp.file(file) - - @property - def enable_cmd_history(self): - """ - :getter: Return whether command history is saved - :setter: Set if command history should be saved - :type: bool - """ - return self._enable_cmd_history - - @enable_cmd_history.setter - def enable_cmd_history(self, value): - """ - :getter: Return whether command history is saved - :setter: Set if command history should be saved - :type: bool - """ - self._enable_cmd_history = (value == True) - - def write_script(self, filepath): - """ - Write LAMMPS script file containing all commands executed up until now - - :param filepath: path to script file that should be written - :type filepath: string - """ - with open(filepath, "w") as f: - for cmd in self._cmd_history: - print(cmd, file=f) - - def clear_cmd_history(self): - """ - Clear LAMMPS command history up to this point - """ - self._cmd_history = [] - - def command(self, cmd): - """ - Execute LAMMPS command - - If :py:attr:`PyLammps.enable_cmd_history` is set to ``True``, commands executed - will be recorded. The entire command history can be written to a file using - :py:meth:`PyLammps.write_script()`. To clear the command history, use - :py:meth:`PyLammps.clear_cmd_history()`. - - :param cmd: command string that should be executed - :type: cmd: string - """ - self.lmp.command(cmd) - - if self.enable_cmd_history: - self._cmd_history.append(cmd) - - def run(self, *args, **kwargs): - """ - Execute LAMMPS run command with given arguments - - All thermo output during the run is captured and saved as new entry in - :py:attr:`PyLammps.runs`. The latest run can be retrieved by - :py:attr:`PyLammps.last_run`. - """ - output = self.__getattr__('run')(*args, **kwargs) - self.runs += get_thermo_data(output) - return output - - @property - def last_run(self): - """ - Return data produced of last completed run command - - :getter: Returns an object containing information about the last run command - :type: dict - """ - if len(self.runs) > 0: - return self.runs[-1] - return None - - @property - def atoms(self): - """ - All atoms of this LAMMPS instance - - :getter: Returns a list of atoms currently in the system - :type: AtomList - """ - return AtomList(self) - - @property - def system(self): - """ - The system state of this LAMMPS instance - - :getter: Returns an object with properties storing the current system state - :type: namedtuple - """ - output = self.lmp_info("system") - output = output[output.index("System information:")+1:] - d = self._parse_info_system(output) - return namedtuple('System', d.keys())(*d.values()) - - @property - def communication(self): - """ - The communication state of this LAMMPS instance - - :getter: Returns an object with properties storing the current communication state - :type: namedtuple - """ - output = self.lmp_info("communication") - output = output[output.index("Communication information:")+1:] - d = self._parse_info_communication(output) - return namedtuple('Communication', d.keys())(*d.values()) - - @property - def computes(self): - """ - The list of active computes of this LAMMPS instance - - :getter: Returns a list of computes that are currently active in this LAMMPS instance - :type: list - """ - output = self.lmp_info("computes") - output = output[output.index("Compute information:")+1:] - return self._parse_element_list(output) - - @property - def dumps(self): - """ - The list of active dumps of this LAMMPS instance - - :getter: Returns a list of dumps that are currently active in this LAMMPS instance - :type: list - """ - output = self.lmp_info("dumps") - output = output[output.index("Dump information:")+1:] - return self._parse_element_list(output) - - @property - def fixes(self): - """ - The list of active fixes of this LAMMPS instance - - :getter: Returns a list of fixes that are currently active in this LAMMPS instance - :type: list - """ - output = self.lmp_info("fixes") - output = output[output.index("Fix information:")+1:] - return self._parse_element_list(output) - - @property - def groups(self): - """ - The list of active atom groups of this LAMMPS instance - - :getter: Returns a list of atom groups that are currently active in this LAMMPS instance - :type: list - """ - output = self.lmp_info("groups") - output = output[output.index("Group information:")+1:] - return self._parse_groups(output) - - @property - def variables(self): - """ - Returns a dictionary of all variables defined in the current LAMMPS instance - - :getter: Returns a dictionary of all variables that are defined in this LAMMPS instance - :type: dict - """ - output = self.lmp_info("variables") - output = output[output.index("Variable information:")+1:] - variables = {} - for v in self._parse_element_list(output): - variables[v['name']] = Variable(self, v['name'], v['style'], v['def']) - return variables - - def eval(self, expr): - """ - Evaluate expression - - :param expr: the expression string that should be evaluated inside of LAMMPS - :type expr: string - - :return: the value of the evaluated expression - :rtype: float if numeric, string otherwise - """ - value = self.lmp_print('"$(%s)"' % expr).strip() - try: - return float(value) - except ValueError: - return value - - def _split_values(self, line): - return [x.strip() for x in line.split(',')] - - def _get_pair(self, value): - return [x.strip() for x in value.split('=')] - - def _parse_info_system(self, output): - system = {} - - for line in output: - if line.startswith("Units"): - system['units'] = self._get_pair(line)[1] - elif line.startswith("Atom style"): - system['atom_style'] = self._get_pair(line)[1] - elif line.startswith("Atom map"): - system['atom_map'] = self._get_pair(line)[1] - elif line.startswith("Atoms"): - parts = self._split_values(line) - system['natoms'] = int(self._get_pair(parts[0])[1]) - system['ntypes'] = int(self._get_pair(parts[1])[1]) - system['style'] = self._get_pair(parts[2])[1] - elif line.startswith("Kspace style"): - system['kspace_style'] = self._get_pair(line)[1] - elif line.startswith("Dimensions"): - system['dimensions'] = int(self._get_pair(line)[1]) - elif line.startswith("Orthogonal box"): - system['orthogonal_box'] = [float(x) for x in self._get_pair(line)[1].split('x')] - elif line.startswith("Boundaries"): - system['boundaries'] = self._get_pair(line)[1] - elif line.startswith("xlo"): - keys, values = [self._split_values(x) for x in self._get_pair(line)] - for key, value in zip(keys, values): - system[key] = float(value) - elif line.startswith("ylo"): - keys, values = [self._split_values(x) for x in self._get_pair(line)] - for key, value in zip(keys, values): - system[key] = float(value) - elif line.startswith("zlo"): - keys, values = [self._split_values(x) for x in self._get_pair(line)] - for key, value in zip(keys, values): - system[key] = float(value) - elif line.startswith("Molecule type"): - system['molecule_type'] = self._get_pair(line)[1] - elif line.startswith("Bonds"): - parts = self._split_values(line) - system['nbonds'] = int(self._get_pair(parts[0])[1]) - system['nbondtypes'] = int(self._get_pair(parts[1])[1]) - system['bond_style'] = self._get_pair(parts[2])[1] - elif line.startswith("Angles"): - parts = self._split_values(line) - system['nangles'] = int(self._get_pair(parts[0])[1]) - system['nangletypes'] = int(self._get_pair(parts[1])[1]) - system['angle_style'] = self._get_pair(parts[2])[1] - elif line.startswith("Dihedrals"): - parts = self._split_values(line) - system['ndihedrals'] = int(self._get_pair(parts[0])[1]) - system['ndihedraltypes'] = int(self._get_pair(parts[1])[1]) - system['dihedral_style'] = self._get_pair(parts[2])[1] - elif line.startswith("Impropers"): - parts = self._split_values(line) - system['nimpropers'] = int(self._get_pair(parts[0])[1]) - system['nimpropertypes'] = int(self._get_pair(parts[1])[1]) - system['improper_style'] = self._get_pair(parts[2])[1] - - return system - - def _parse_info_communication(self, output): - comm = {} - - for line in output: - if line.startswith("MPI library"): - comm['mpi_version'] = line.split(':')[1].strip() - elif line.startswith("Comm style"): - parts = self._split_values(line) - comm['comm_style'] = self._get_pair(parts[0])[1] - comm['comm_layout'] = self._get_pair(parts[1])[1] - elif line.startswith("Processor grid"): - comm['proc_grid'] = [int(x) for x in self._get_pair(line)[1].split('x')] - elif line.startswith("Communicate velocities for ghost atoms"): - comm['ghost_velocity'] = (self._get_pair(line)[1] == "yes") - elif line.startswith("Nprocs"): - parts = self._split_values(line) - comm['nprocs'] = int(self._get_pair(parts[0])[1]) - comm['nthreads'] = int(self._get_pair(parts[1])[1]) - return comm - - def _parse_element_list(self, output): - elements = [] - - for line in output: - if not line or (":" not in line): continue - element_info = self._split_values(line.split(':')[1].strip()) - element = {'name': element_info[0]} - for key, value in [self._get_pair(x) for x in element_info[1:]]: - element[key] = value - elements.append(element) - return elements - - def _parse_groups(self, output): - groups = [] - group_pattern = re.compile(r"(?P.+) \((?P.+)\)") - - for line in output: - m = group_pattern.match(line.split(':')[1].strip()) - group = {'name': m.group('name'), 'type': m.group('type')} - groups.append(group) - return groups - - def lmp_print(self, s): - """ needed for Python2 compatibility, since print is a reserved keyword """ - return self.__getattr__("print")(s) - - def __dir__(self): - return sorted(set(['angle_coeff', 'angle_style', 'atom_modify', 'atom_style', 'atom_style', - 'bond_coeff', 'bond_style', 'boundary', 'change_box', 'communicate', 'compute', - 'create_atoms', 'create_box', 'delete_atoms', 'delete_bonds', 'dielectric', - 'dihedral_coeff', 'dihedral_style', 'dimension', 'dump', 'fix', 'fix_modify', - 'group', 'improper_coeff', 'improper_style', 'include', 'kspace_modify', - 'kspace_style', 'lattice', 'mass', 'minimize', 'min_style', 'neighbor', - 'neigh_modify', 'newton', 'nthreads', 'pair_coeff', 'pair_modify', - 'pair_style', 'processors', 'read', 'read_data', 'read_restart', 'region', - 'replicate', 'reset_timestep', 'restart', 'run', 'run_style', 'thermo', - 'thermo_modify', 'thermo_style', 'timestep', 'undump', 'unfix', 'units', - 'variable', 'velocity', 'write_restart'] + self.lmp.available_styles("command"))) - - def lmp_info(self, s): - # skip anything before and after Info-Info-Info - # also skip timestamp line - output = self.__getattr__("info")(s) - indices = [index for index, line in enumerate(output) if line.startswith("Info-Info-Info-Info")] - start = indices[0] - end = indices[1] - return [line for line in output[start+2:end] if line] - - def __getattr__(self, name): - """ - This method is where the Python 'magic' happens. If a method is not - defined by the class PyLammps, it assumes it is a LAMMPS command. It takes - all the arguments, concatinates them to a single string, and executes it using - :py:meth:`lammps.PyLammps.command()`. - - :param verbose: Print output of command - :type verbose: bool - :return: line or list of lines of output, None if no output - :rtype: list or string - """ - def handler(*args, **kwargs): - cmd_args = [name] + [str(x) for x in args] - self.lmp.flush_buffers() - - with OutputCapture() as capture: - cmd = ' '.join(cmd_args) - self.command(cmd) - self.lmp.flush_buffers() - output = capture.output - - comm = self.lmp.get_mpi_comm() - if comm: - output = self.lmp.comm.bcast(output, root=0) - - if self.verbose or ('verbose' in kwargs and kwargs['verbose']): - print(output, end = '') - - lines = output.splitlines() - - if self.has_echo: - lines = lines[1:] - - if len(lines) > 1: - return lines - elif len(lines) == 1: - return lines[0] - return None - - return handler - - -class IPyLammps(PyLammps): - """ - IPython wrapper for LAMMPS which adds embedded graphics capabilities to PyLammmps interface - - It either creates its own instance of :py:class:`lammps` or can be - initialized with an existing instance. The arguments are the same of the - lower-level interface. The original interface can still be accessed via - :py:attr:`PyLammps.lmp`. - - :param name: "machine" name of the shared LAMMPS library ("mpi" loads ``liblammps_mpi.so``, "" loads ``liblammps.so``) - :type name: string - :param cmdargs: list of command line arguments to be passed to the :cpp:func:`lammps_open` function. The executable name is automatically added. - :type cmdargs: list - :param ptr: pointer to a LAMMPS C++ class instance when called from an embedded Python interpreter. None means load symbols from shared library. - :type ptr: pointer - :param comm: MPI communicator (as provided by `mpi4py `_). ``None`` means use ``MPI_COMM_WORLD`` implicitly. - :type comm: MPI_Comm - """ - - def __init__(self,name="",cmdargs=None,ptr=None,comm=None): - super(IPyLammps, self).__init__(name=name,cmdargs=cmdargs,ptr=ptr,comm=comm) - - def image(self, filename="snapshot.png", group="all", color="type", diameter="type", - size=None, view=None, center=None, up=None, zoom=1.0, background_color="white"): - """ Generate image using write_dump command and display it - - See :doc:`dump image ` for more information. - - :param filename: Name of the image file that should be generated. The extension determines whether it is PNG or JPEG - :type filename: string - :param group: the group of atoms write_image should use - :type group: string - :param color: name of property used to determine color - :type color: string - :param diameter: name of property used to determine atom diameter - :type diameter: string - :param size: dimensions of image - :type size: tuple (width, height) - :param view: view parameters - :type view: tuple (theta, phi) - :param center: center parameters - :type center: tuple (flag, center_x, center_y, center_z) - :param up: vector pointing to up direction - :type up: tuple (up_x, up_y, up_z) - :param zoom: zoom factor - :type zoom: float - :param background_color: background color of scene - :type background_color: string - - :return: Image instance used to display image in notebook - :rtype: :py:class:`IPython.core.display.Image` - """ - cmd_args = [group, "image", filename, color, diameter] - - if size is not None: - width = size[0] - height = size[1] - cmd_args += ["size", width, height] - - if view is not None: - theta = view[0] - phi = view[1] - cmd_args += ["view", theta, phi] - - if center is not None: - flag = center[0] - Cx = center[1] - Cy = center[2] - Cz = center[3] - cmd_args += ["center", flag, Cx, Cy, Cz] - - if up is not None: - Ux = up[0] - Uy = up[1] - Uz = up[2] - cmd_args += ["up", Ux, Uy, Uz] - - if zoom is not None: - cmd_args += ["zoom", zoom] - - cmd_args.append("modify backcolor " + background_color) - - self.write_dump(*cmd_args) - from IPython.core.display import Image - return Image(filename) - - def video(self, filename): - """ - Load video from file - - Can be used to visualize videos from :doc:`dump movie `. - - :param filename: Path to video file - :type filename: string - :return: HTML Video Tag used by notebook to embed a video - :rtype: :py:class:`IPython.display.HTML` - """ - from IPython.display import HTML - return HTML("") From 8f431c5904f1324d981aa149ff3e3896e8b862c7 Mon Sep 17 00:00:00 2001 From: rohskopf Date: Thu, 7 Jul 2022 17:05:03 -0600 Subject: [PATCH 553/585] Add python/lammps directory back --- python/lammps/__init__.py | 49 + python/lammps/constants.py | 48 + python/lammps/core.py | 2097 +++++++++++++++++++++++++++++++ python/lammps/data.py | 92 ++ python/lammps/formats.py | 227 ++++ python/lammps/mliap/__init__.py | 20 + python/lammps/mliap/loader.py | 52 + python/lammps/mliap/pytorch.py | 326 +++++ python/lammps/numpy_wrapper.py | 483 +++++++ python/lammps/pylammps.py | 990 +++++++++++++++ 10 files changed, 4384 insertions(+) create mode 100644 python/lammps/__init__.py create mode 100644 python/lammps/constants.py create mode 100644 python/lammps/core.py create mode 100644 python/lammps/data.py create mode 100644 python/lammps/formats.py create mode 100644 python/lammps/mliap/__init__.py create mode 100644 python/lammps/mliap/loader.py create mode 100644 python/lammps/mliap/pytorch.py create mode 100644 python/lammps/numpy_wrapper.py create mode 100644 python/lammps/pylammps.py diff --git a/python/lammps/__init__.py b/python/lammps/__init__.py new file mode 100644 index 0000000000..fc35e45225 --- /dev/null +++ b/python/lammps/__init__.py @@ -0,0 +1,49 @@ +""" +LAMMPS module global members: + +.. data:: __version__ + + Numerical representation of the LAMMPS version this + module was taken from. Has the same format as the + result of :py:func:`lammps.version`. +""" + +from .constants import * # lgtm [py/polluting-import] +from .core import * # lgtm [py/polluting-import] +from .data import * # lgtm [py/polluting-import] +from .pylammps import * # lgtm [py/polluting-import] + +# convert installed module string version to numeric version +def get_version_number(): + import time + from os.path import join + from sys import version_info + + # must report 0 when inside LAMMPS source tree + if __file__.find(join('python', 'lammps', '__init__.py')) > 0: + return 0 + + vstring = None + if version_info.major == 3 and version_info.minor >= 8: + from importlib.metadata import version, PackageNotFoundError + try: + vstring = version('lammps') + except PackageNotFoundError: + # nothing to do, ignore + pass + + else: + from pkg_resources import get_distribution, DistributionNotFound + try: + vstring = get_distribution('lammps').version + except DistributionNotFound: + # nothing to do, ignore + pass + + if not vstring: + return 0 + + t = time.strptime(vstring, "%Y.%m.%d") + return t.tm_year*10000 + t.tm_mon*100 + t.tm_mday + +__version__ = get_version_number() diff --git a/python/lammps/constants.py b/python/lammps/constants.py new file mode 100644 index 0000000000..a50d58b28f --- /dev/null +++ b/python/lammps/constants.py @@ -0,0 +1,48 @@ +# ---------------------------------------------------------------------- +# LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator +# https://www.lammps.org/ Sandia National Laboratories +# Steve Plimpton, sjplimp@sandia.gov +# +# Copyright (2003) Sandia Corporation. Under the terms of Contract +# DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains +# certain rights in this software. This software is distributed under +# the GNU General Public License. +# +# See the README file in the top-level LAMMPS directory. +# ------------------------------------------------------------------------- + +# various symbolic constants to be used +# in certain calls to select data formats +LAMMPS_AUTODETECT = None +LAMMPS_INT = 0 +LAMMPS_INT_2D = 1 +LAMMPS_DOUBLE = 2 +LAMMPS_DOUBLE_2D = 3 +LAMMPS_INT64 = 4 +LAMMPS_INT64_2D = 5 +LAMMPS_STRING = 6 + +# these must be kept in sync with the enums in library.h +LMP_STYLE_GLOBAL = 0 +LMP_STYLE_ATOM = 1 +LMP_STYLE_LOCAL = 2 + +LMP_TYPE_SCALAR = 0 +LMP_TYPE_VECTOR = 1 +LMP_TYPE_ARRAY = 2 +LMP_SIZE_VECTOR = 3 +LMP_SIZE_ROWS = 4 +LMP_SIZE_COLS = 5 + +LMP_VAR_EQUAL = 0 +LMP_VAR_ATOM = 1 + +# ------------------------------------------------------------------------- + +def get_ctypes_int(size): + from ctypes import c_int, c_int32, c_int64 + if size == 4: + return c_int32 + elif size == 8: + return c_int64 + return c_int diff --git a/python/lammps/core.py b/python/lammps/core.py new file mode 100644 index 0000000000..930a40a4b0 --- /dev/null +++ b/python/lammps/core.py @@ -0,0 +1,2097 @@ +# ---------------------------------------------------------------------- +# LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator +# https://www.lammps.org/ Sandia National Laboratories +# Steve Plimpton, sjplimp@sandia.gov +# +# Copyright (2003) Sandia Corporation. Under the terms of Contract +# DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains +# certain rights in this software. This software is distributed under +# the GNU General Public License. +# +# See the README file in the top-level LAMMPS directory. +# ------------------------------------------------------------------------- +# Python wrapper for the LAMMPS library via ctypes + +# for python2/3 compatibility + +from __future__ import print_function + +import os +import sys +from ctypes import * # lgtm [py/polluting-import] +from os.path import dirname,abspath,join +from inspect import getsourcefile + +from .constants import * # lgtm [py/polluting-import] +from .data import * # lgtm [py/polluting-import] + +# ------------------------------------------------------------------------- + +class MPIAbortException(Exception): + def __init__(self, message): + self.message = message + + def __str__(self): + return repr(self.message) + +# ------------------------------------------------------------------------- + +class ExceptionCheck: + """Utility class to rethrow LAMMPS C++ exceptions as Python exceptions""" + def __init__(self, lmp): + self.lmp = lmp + + def __enter__(self): + pass + + def __exit__(self, exc_type, exc_value, traceback): + if self.lmp.has_exceptions and self.lmp.lib.lammps_has_error(self.lmp.lmp): + raise self.lmp._lammps_exception + +# ------------------------------------------------------------------------- + +class lammps(object): + """Create an instance of the LAMMPS Python class. + + .. _mpi4py_docs: https://mpi4py.readthedocs.io/ + + This is a Python wrapper class that exposes the LAMMPS C-library + interface to Python. It either requires that LAMMPS has been compiled + as shared library which is then dynamically loaded via the ctypes + Python module or that this module called from a Python function that + is called from a Python interpreter embedded into a LAMMPS executable, + for example through the :doc:`python invoke ` command. + When the class is instantiated it calls the :cpp:func:`lammps_open` + function of the LAMMPS C-library interface, which in + turn will create an instance of the :cpp:class:`LAMMPS ` + C++ class. The handle to this C++ class is stored internally + and automatically passed to the calls to the C library interface. + + :param name: "machine" name of the shared LAMMPS library ("mpi" loads ``liblammps_mpi.so``, "" loads ``liblammps.so``) + :type name: string + :param cmdargs: list of command line arguments to be passed to the :cpp:func:`lammps_open` function. The executable name is automatically added. + :type cmdargs: list + :param ptr: pointer to a LAMMPS C++ class instance when called from an embedded Python interpreter. None means load symbols from shared library. + :type ptr: pointer + :param comm: MPI communicator (as provided by `mpi4py `_). ``None`` means use ``MPI_COMM_WORLD`` implicitly. + :type comm: MPI_Comm + """ + + # ------------------------------------------------------------------------- + # create an instance of LAMMPS + + def __init__(self,name='',cmdargs=None,ptr=None,comm=None): + self.comm = comm + self.opened = 0 + + # determine module file location + + modpath = dirname(abspath(getsourcefile(lambda:0))) + # for windows installers the shared library is in a different folder + winpath = abspath(os.path.join(modpath,'..','..','bin')) + # allow override for running tests on Windows + if (os.environ.get("LAMMPSDLLPATH")): + winpath = os.environ.get("LAMMPSDLLPATH") + self.lib = None + self.lmp = None + + # if a pointer to a LAMMPS object is handed in + # when being called from a Python interpreter + # embedded into a LAMMPS executable, all library + # symbols should already be available so we do not + # load a shared object. + + try: + if ptr is not None: self.lib = CDLL("",RTLD_GLOBAL) + except OSError: + self.lib = None + + # load liblammps.so unless name is given + # if name = "g++", load liblammps_g++.so + # try loading the LAMMPS shared object from the location + # of the lammps package with an absolute path, + # so that LD_LIBRARY_PATH does not need to be set for regular install + # fall back to loading with a relative path, + # typically requires LD_LIBRARY_PATH to be set appropriately + # guess shared library extension based on OS, if not inferred from actual file + + if any([f.startswith('liblammps') and f.endswith('.dylib') + for f in os.listdir(modpath)]): + lib_ext = ".dylib" + elif any([f.startswith('liblammps') and f.endswith('.dll') + for f in os.listdir(modpath)]): + lib_ext = ".dll" + elif os.path.exists(winpath) and any([f.startswith('liblammps') and f.endswith('.dll') + for f in os.listdir(winpath)]): + lib_ext = ".dll" + modpath = winpath + elif any([f.startswith('liblammps') and f.endswith('.so') + for f in os.listdir(modpath)]): + lib_ext = ".so" + else: + import platform + if platform.system() == "Darwin": + lib_ext = ".dylib" + elif platform.system() == "Windows": + lib_ext = ".dll" + else: + lib_ext = ".so" + + if not self.lib: + if name: + libpath = join(modpath,"liblammps_%s" % name + lib_ext) + else: + libpath = join(modpath,"liblammps" + lib_ext) + if not os.path.isfile(libpath): + if name: + libpath = "liblammps_%s" % name + lib_ext + else: + libpath = "liblammps" + lib_ext + self.lib = CDLL(libpath,RTLD_GLOBAL) + + # declare all argument and return types for all library methods here. + # exceptions are where the arguments depend on certain conditions and + # then are defined where the functions are used. + self.lib.lammps_extract_setting.argtypes = [c_void_p, c_char_p] + self.lib.lammps_extract_setting.restype = c_int + + # set default types + # needed in later declarations + self.c_bigint = get_ctypes_int(self.extract_setting("bigint")) + self.c_tagint = get_ctypes_int(self.extract_setting("tagint")) + self.c_imageint = get_ctypes_int(self.extract_setting("imageint")) + + self.lib.lammps_open.restype = c_void_p + self.lib.lammps_open_no_mpi.restype = c_void_p + self.lib.lammps_close.argtypes = [c_void_p] + self.lib.lammps_flush_buffers.argtypes = [c_void_p] + self.lib.lammps_free.argtypes = [c_void_p] + + self.lib.lammps_file.argtypes = [c_void_p, c_char_p] + self.lib.lammps_file.restype = None + + self.lib.lammps_command.argtypes = [c_void_p, c_char_p] + self.lib.lammps_command.restype = c_char_p + self.lib.lammps_commands_list.restype = None + self.lib.lammps_commands_string.argtypes = [c_void_p, c_char_p] + self.lib.lammps_commands_string.restype = None + + self.lib.lammps_get_natoms.argtypes = [c_void_p] + self.lib.lammps_get_natoms.restype = c_double + self.lib.lammps_extract_box.argtypes = \ + [c_void_p,POINTER(c_double),POINTER(c_double), + POINTER(c_double),POINTER(c_double),POINTER(c_double), + POINTER(c_int),POINTER(c_int)] + self.lib.lammps_extract_box.restype = None + + self.lib.lammps_reset_box.argtypes = \ + [c_void_p,POINTER(c_double),POINTER(c_double),c_double,c_double,c_double] + self.lib.lammps_reset_box.restype = None + + self.lib.lammps_gather_atoms.argtypes = [c_void_p,c_char_p,c_int,c_int,c_void_p] + self.lib.lammps_gather_atoms.restype = None + + self.lib.lammps_gather_atoms_concat.argtypes = [c_void_p,c_char_p,c_int,c_int,c_void_p] + self.lib.lammps_gather_atoms_concat.restype = None + + self.lib.lammps_gather_atoms_subset.argtypes = \ + [c_void_p,c_char_p,c_int,c_int,c_int,POINTER(c_int),c_void_p] + self.lib.lammps_gather_atoms_subset.restype = None + + self.lib.lammps_scatter_atoms.argtypes = [c_void_p,c_char_p,c_int,c_int,c_void_p] + self.lib.lammps_scatter_atoms.restype = None + + self.lib.lammps_scatter_atoms_subset.argtypes = \ + [c_void_p,c_char_p,c_int,c_int,c_int,POINTER(c_int),c_void_p] + self.lib.lammps_scatter_atoms_subset.restype = None + + self.lib.lammps_gather_bonds.argtypes = [c_void_p,c_void_p] + self.lib.lammps_gather_bonds.restype = None + + self.lib.lammps_gather.argtypes = [c_void_p,c_char_p,c_int,c_int,c_void_p] + self.lib.lammps_gather.restype = None + + self.lib.lammps_gather_concat.argtypes = [c_void_p,c_char_p,c_int,c_int,c_void_p] + self.lib.lammps_gather_concat.restype = None + + self.lib.lammps_gather_subset.argtypes = \ + [c_void_p,c_char_p,c_int,c_int,c_int,POINTER(c_int),c_void_p] + self.lib.lammps_gather_subset.restype = None + + self.lib.lammps_scatter.argtypes = [c_void_p,c_char_p,c_int,c_int,c_void_p] + self.lib.lammps_scatter.restype = None + + self.lib.lammps_scatter_subset.argtypes = \ + [c_void_p,c_char_p,c_int,c_int,c_int,POINTER(c_int),c_void_p] + self.lib.lammps_scatter_subset.restype = None + + + self.lib.lammps_find_pair_neighlist.argtypes = [c_void_p, c_char_p, c_int, c_int, c_int] + self.lib.lammps_find_pair_neighlist.restype = c_int + + self.lib.lammps_find_fix_neighlist.argtypes = [c_void_p, c_char_p, c_int] + self.lib.lammps_find_fix_neighlist.restype = c_int + + self.lib.lammps_find_compute_neighlist.argtypes = [c_void_p, c_char_p, c_int] + self.lib.lammps_find_compute_neighlist.restype = c_int + + self.lib.lammps_neighlist_num_elements.argtypes = [c_void_p, c_int] + self.lib.lammps_neighlist_num_elements.restype = c_int + + self.lib.lammps_neighlist_element_neighbors.argtypes = \ + [c_void_p, c_int, c_int, POINTER(c_int), POINTER(c_int), POINTER(POINTER(c_int))] + self.lib.lammps_neighlist_element_neighbors.restype = None + + self.lib.lammps_is_running.argtypes = [c_void_p] + self.lib.lammps_is_running.restype = c_int + + self.lib.lammps_force_timeout.argtypes = [c_void_p] + + self.lib.lammps_has_error.argtypes = [c_void_p] + self.lib.lammps_has_error.restype = c_int + + self.lib.lammps_get_last_error_message.argtypes = [c_void_p, c_char_p, c_int] + self.lib.lammps_get_last_error_message.restype = c_int + + self.lib.lammps_extract_global.argtypes = [c_void_p, c_char_p] + self.lib.lammps_extract_global_datatype.argtypes = [c_void_p, c_char_p] + self.lib.lammps_extract_global_datatype.restype = c_int + self.lib.lammps_extract_compute.argtypes = [c_void_p, c_char_p, c_int, c_int] + + self.lib.lammps_get_thermo.argtypes = [c_void_p, c_char_p] + self.lib.lammps_get_thermo.restype = c_double + + self.lib.lammps_encode_image_flags.restype = self.c_imageint + + self.lib.lammps_config_package_name.argtypes = [c_int, c_char_p, c_int] + self.lib.lammps_config_accelerator.argtypes = [c_char_p, c_char_p, c_char_p] + + self.lib.lammps_set_variable.argtypes = [c_void_p, c_char_p, c_char_p] + + self.lib.lammps_has_style.argtypes = [c_void_p, c_char_p, c_char_p] + + self.lib.lammps_style_count.argtypes = [c_void_p, c_char_p] + + self.lib.lammps_style_name.argtypes = [c_void_p, c_char_p, c_int, c_char_p, c_int] + + self.lib.lammps_has_id.argtypes = [c_void_p, c_char_p, c_char_p] + + self.lib.lammps_id_count.argtypes = [c_void_p, c_char_p] + + self.lib.lammps_id_name.argtypes = [c_void_p, c_char_p, c_int, c_char_p, c_int] + + self.lib.lammps_plugin_count.argtypes = [ ] + self.lib.lammps_plugin_name.argtypes = [c_int, c_char_p, c_char_p, c_int] + + self.lib.lammps_version.argtypes = [c_void_p] + + self.lib.lammps_get_os_info.argtypes = [c_char_p, c_int] + self.lib.lammps_get_gpu_device_info.argtypes = [c_char_p, c_int] + + self.lib.lammps_get_mpi_comm.argtypes = [c_void_p] + + self.lib.lammps_decode_image_flags.argtypes = [self.c_imageint, POINTER(c_int*3)] + + self.lib.lammps_extract_atom.argtypes = [c_void_p, c_char_p] + self.lib.lammps_extract_atom_datatype.argtypes = [c_void_p, c_char_p] + self.lib.lammps_extract_atom_datatype.restype = c_int + + self.lib.lammps_extract_fix.argtypes = [c_void_p, c_char_p, c_int, c_int, c_int, c_int] + + self.lib.lammps_extract_variable.argtypes = [c_void_p, c_char_p, c_char_p] + + self.lib.lammps_fix_external_get_force.argtypes = [c_void_p, c_char_p] + self.lib.lammps_fix_external_get_force.restype = POINTER(POINTER(c_double)) + + self.lib.lammps_fix_external_set_energy_global.argtypes = [c_void_p, c_char_p, c_double] + self.lib.lammps_fix_external_set_virial_global.argtypes = [c_void_p, c_char_p, POINTER(c_double)] + self.lib.lammps_fix_external_set_energy_peratom.argtypes = [c_void_p, c_char_p, POINTER(c_double)] + self.lib.lammps_fix_external_set_virial_peratom.argtypes = [c_void_p, c_char_p, POINTER(POINTER(c_double))] + + self.lib.lammps_fix_external_set_vector_length.argtypes = [c_void_p, c_char_p, c_int] + self.lib.lammps_fix_external_set_vector.argtypes = [c_void_p, c_char_p, c_int, c_double] + + # detect if Python is using a version of mpi4py that can pass communicators + # only needed if LAMMPS has been compiled with MPI support. + self.has_mpi4py = False + if self.has_mpi_support: + try: + from mpi4py import __version__ as mpi4py_version + # tested to work with mpi4py versions 2 and 3 + self.has_mpi4py = mpi4py_version.split('.')[0] in ['2','3'] + except ImportError: + # ignore failing import + pass + + # if no ptr provided, create an instance of LAMMPS + # we can pass an MPI communicator from mpi4py v2.0.0 and later + # no_mpi call lets LAMMPS use MPI_COMM_WORLD + # cargs = array of C strings from args + # if ptr, then are embedding Python in LAMMPS input script + # ptr is the desired instance of LAMMPS + # just convert it to ctypes ptr and store in self.lmp + + if ptr is None: + + # with mpi4py v2+, we can pass MPI communicators to LAMMPS + # need to adjust for type of MPI communicator object + # allow for int (like MPICH) or void* (like OpenMPI) + if self.has_mpi_support and self.has_mpi4py: + from mpi4py import MPI + self.MPI = MPI + + if comm is not None: + if not self.has_mpi_support: + raise Exception('LAMMPS not compiled with real MPI library') + if not self.has_mpi4py: + raise Exception('Python mpi4py version is not 2 or 3') + if self.MPI._sizeof(self.MPI.Comm) == sizeof(c_int): + MPI_Comm = c_int + else: + MPI_Comm = c_void_p + + # Detect whether LAMMPS and mpi4py definitely use different MPI libs + if sizeof(MPI_Comm) != self.lib.lammps_config_has_mpi_support(): + raise Exception('Inconsistent MPI library in LAMMPS and mpi4py') + + narg = 0 + cargs = None + if cmdargs is not None: + cmdargs.insert(0,"lammps") + narg = len(cmdargs) + for i in range(narg): + if type(cmdargs[i]) is str: + cmdargs[i] = cmdargs[i].encode() + cargs = (c_char_p*narg)(*cmdargs) + self.lib.lammps_open.argtypes = [c_int, c_char_p*narg, MPI_Comm, c_void_p] + else: + self.lib.lammps_open.argtypes = [c_int, c_char_p, MPI_Comm, c_void_p] + + self.opened = 1 + comm_ptr = self.MPI._addressof(comm) + comm_val = MPI_Comm.from_address(comm_ptr) + self.lmp = c_void_p(self.lib.lammps_open(narg,cargs,comm_val,None)) + + else: + if self.has_mpi4py and self.has_mpi_support: + self.comm = self.MPI.COMM_WORLD + self.opened = 1 + if cmdargs is not None: + cmdargs.insert(0,"lammps") + narg = len(cmdargs) + for i in range(narg): + if type(cmdargs[i]) is str: + cmdargs[i] = cmdargs[i].encode() + cargs = (c_char_p*narg)(*cmdargs) + self.lib.lammps_open_no_mpi.argtypes = [c_int, c_char_p*narg, c_void_p] + self.lmp = c_void_p(self.lib.lammps_open_no_mpi(narg,cargs,None)) + else: + self.lib.lammps_open_no_mpi.argtypes = [c_int, c_char_p, c_void_p] + self.lmp = c_void_p(self.lib.lammps_open_no_mpi(0,None,None)) + + else: + # magic to convert ptr to ctypes ptr + if sys.version_info >= (3, 0): + # Python 3 (uses PyCapsule API) + pythonapi.PyCapsule_GetPointer.restype = c_void_p + pythonapi.PyCapsule_GetPointer.argtypes = [py_object, c_char_p] + self.lmp = c_void_p(pythonapi.PyCapsule_GetPointer(ptr, None)) + else: + # Python 2 (uses PyCObject API) + pythonapi.PyCObject_AsVoidPtr.restype = c_void_p + pythonapi.PyCObject_AsVoidPtr.argtypes = [py_object] + self.lmp = c_void_p(pythonapi.PyCObject_AsVoidPtr(ptr)) + + # check if library initilialization failed + if not self.lmp: + raise(RuntimeError("Failed to initialize LAMMPS object")) + + # optional numpy support (lazy loading) + self._numpy = None + + self._installed_packages = None + self._available_styles = None + + # check if liblammps version matches the installed python module version + # but not for in-place usage, i.e. when the version is 0 + import lammps + if lammps.__version__ > 0 and lammps.__version__ != self.lib.lammps_version(self.lmp): + raise(AttributeError("LAMMPS Python module installed for LAMMPS version %d, but shared library is version %d" \ + % (lammps.__version__, self.lib.lammps_version(self.lmp)))) + + # add way to insert Python callback for fix external + self.callback = {} + self.FIX_EXTERNAL_CALLBACK_FUNC = CFUNCTYPE(None, py_object, self.c_bigint, c_int, POINTER(self.c_tagint), POINTER(POINTER(c_double)), POINTER(POINTER(c_double))) + self.lib.lammps_set_fix_external_callback.argtypes = [c_void_p, c_char_p, self.FIX_EXTERNAL_CALLBACK_FUNC, py_object] + self.lib.lammps_set_fix_external_callback.restype = None + + # ------------------------------------------------------------------------- + # shut-down LAMMPS instance + + def __del__(self): + self.close() + + # ------------------------------------------------------------------------- + # context manager implementation + + def __enter__(self): + return self + + def __exit__(self, ex_type, ex_value, ex_traceback): + self.close() + + # ------------------------------------------------------------------------- + + @property + def numpy(self): + """ Return object to access numpy versions of API + + It provides alternative implementations of API functions that + return numpy arrays instead of ctypes pointers. If numpy is not installed, + accessing this property will lead to an ImportError. + + :return: instance of numpy wrapper object + :rtype: numpy_wrapper + """ + if not self._numpy: + from .numpy_wrapper import numpy_wrapper + self._numpy = numpy_wrapper(self) + return self._numpy + + # ------------------------------------------------------------------------- + + def close(self): + """Explicitly delete a LAMMPS instance through the C-library interface. + + This is a wrapper around the :cpp:func:`lammps_close` function of the C-library interface. + """ + if self.lmp and self.opened: + self.lib.lammps_close(self.lmp) + self.lmp = None + self.opened = 0 + + # ------------------------------------------------------------------------- + + def finalize(self): + """Shut down the MPI communication and Kokkos environment (if active) through the + library interface by calling :cpp:func:`lammps_mpi_finalize` and + :cpp:func:`lammps_kokkos_finalize`. + + You cannot create or use any LAMMPS instances after this function is called + unless LAMMPS was compiled without MPI and without Kokkos support. + """ + self.close() + self.lib.lammps_kokkos_finalize() + self.lib.lammps_mpi_finalize() + + # ------------------------------------------------------------------------- + + def version(self): + """Return a numerical representation of the LAMMPS version in use. + + This is a wrapper around the :cpp:func:`lammps_version` function of the C-library interface. + + :return: version number + :rtype: int + """ + return self.lib.lammps_version(self.lmp) + + # ------------------------------------------------------------------------- + + def get_os_info(self): + """Return a string with information about the OS and compiler runtime + + This is a wrapper around the :cpp:func:`lammps_get_os_info` function of the C-library interface. + + :return: OS info string + :rtype: string + """ + + sb = create_string_buffer(512) + self.lib.lammps_get_os_info(sb,512) + return sb.value.decode() + + # ------------------------------------------------------------------------- + + def get_mpi_comm(self): + """Get the MPI communicator in use by the current LAMMPS instance + + This is a wrapper around the :cpp:func:`lammps_get_mpi_comm` function + of the C-library interface. It will return ``None`` if either the + LAMMPS library was compiled without MPI support or the mpi4py + Python module is not available. + + :return: MPI communicator + :rtype: MPI_Comm + """ + + if self.has_mpi4py and self.has_mpi_support: + from mpi4py import MPI + f_comm = self.lib.lammps_get_mpi_comm(self.lmp) + c_comm = MPI.Comm.f2py(f_comm) + return c_comm + else: + return None + + # ------------------------------------------------------------------------- + + @property + def _lammps_exception(self): + sb = create_string_buffer(100) + error_type = self.lib.lammps_get_last_error_message(self.lmp, sb, 100) + error_msg = sb.value.decode().strip() + + if error_type == 2: + return MPIAbortException(error_msg) + return Exception(error_msg) + + # ------------------------------------------------------------------------- + + def file(self, path): + """Read LAMMPS commands from a file. + + This is a wrapper around the :cpp:func:`lammps_file` function of the C-library interface. + It will open the file with the name/path `file` and process the LAMMPS commands line by line until + the end. The function will return when the end of the file is reached. + + :param path: Name of the file/path with LAMMPS commands + :type path: string + """ + if path: path = path.encode() + else: return + + with ExceptionCheck(self): + self.lib.lammps_file(self.lmp, path) + + # ------------------------------------------------------------------------- + + def command(self,cmd): + """Process a single LAMMPS input command from a string. + + This is a wrapper around the :cpp:func:`lammps_command` + function of the C-library interface. + + :param cmd: a single lammps command + :type cmd: string + """ + if cmd: cmd = cmd.encode() + else: return + + with ExceptionCheck(self): + self.lib.lammps_command(self.lmp,cmd) + + # ------------------------------------------------------------------------- + + def commands_list(self,cmdlist): + """Process multiple LAMMPS input commands from a list of strings. + + This is a wrapper around the + :cpp:func:`lammps_commands_list` function of + the C-library interface. + + :param cmdlist: a single lammps command + :type cmdlist: list of strings + """ + cmds = [x.encode() for x in cmdlist if type(x) is str] + narg = len(cmdlist) + args = (c_char_p * narg)(*cmds) + self.lib.lammps_commands_list.argtypes = [c_void_p, c_int, c_char_p * narg] + + with ExceptionCheck(self): + self.lib.lammps_commands_list(self.lmp,narg,args) + + # ------------------------------------------------------------------------- + + def commands_string(self,multicmd): + """Process a block of LAMMPS input commands from a string. + + This is a wrapper around the + :cpp:func:`lammps_commands_string` + function of the C-library interface. + + :param multicmd: text block of lammps commands + :type multicmd: string + """ + if type(multicmd) is str: multicmd = multicmd.encode() + + with ExceptionCheck(self): + self.lib.lammps_commands_string(self.lmp,c_char_p(multicmd)) + + # ------------------------------------------------------------------------- + + def get_natoms(self): + """Get the total number of atoms in the LAMMPS instance. + + Will be precise up to 53-bit signed integer due to the + underlying :cpp:func:`lammps_get_natoms` function returning a double. + + :return: number of atoms + :rtype: int + """ + return int(self.lib.lammps_get_natoms(self.lmp)) + + # ------------------------------------------------------------------------- + + def extract_box(self): + """Extract simulation box parameters + + This is a wrapper around the :cpp:func:`lammps_extract_box` function + of the C-library interface. Unlike in the C function, the result is + returned as a list. + + :return: list of the extracted data: boxlo, boxhi, xy, yz, xz, periodicity, box_change + :rtype: [ 3*double, 3*double, double, double, 3*int, int] + """ + boxlo = (3*c_double)() + boxhi = (3*c_double)() + xy = c_double() + yz = c_double() + xz = c_double() + periodicity = (3*c_int)() + box_change = c_int() + + with ExceptionCheck(self): + self.lib.lammps_extract_box(self.lmp,boxlo,boxhi, + byref(xy),byref(yz),byref(xz), + periodicity,byref(box_change)) + + boxlo = boxlo[:3] + boxhi = boxhi[:3] + xy = xy.value + yz = yz.value + xz = xz.value + periodicity = periodicity[:3] + box_change = box_change.value + + return boxlo,boxhi,xy,yz,xz,periodicity,box_change + + # ------------------------------------------------------------------------- + + def reset_box(self,boxlo,boxhi,xy,yz,xz): + """Reset simulation box parameters + + This is a wrapper around the :cpp:func:`lammps_reset_box` function + of the C-library interface. + + :param boxlo: new lower box boundaries + :type boxlo: list of 3 floating point numbers + :param boxhi: new upper box boundaries + :type boxhi: list of 3 floating point numbers + :param xy: xy tilt factor + :type xy: float + :param yz: yz tilt factor + :type yz: float + :param xz: xz tilt factor + :type xz: float + """ + cboxlo = (3*c_double)(*boxlo) + cboxhi = (3*c_double)(*boxhi) + with ExceptionCheck(self): + self.lib.lammps_reset_box(self.lmp,cboxlo,cboxhi,xy,yz,xz) + + # ------------------------------------------------------------------------- + + def get_thermo(self,name): + """Get current value of a thermo keyword + + This is a wrapper around the :cpp:func:`lammps_get_thermo` + function of the C-library interface. + + :param name: name of thermo keyword + :type name: string + :return: value of thermo keyword + :rtype: double or None + """ + if name: name = name.encode() + else: return None + + with ExceptionCheck(self): + return self.lib.lammps_get_thermo(self.lmp,name) + + # ------------------------------------------------------------------------- + + def extract_setting(self, name): + """Query LAMMPS about global settings that can be expressed as an integer. + + This is a wrapper around the :cpp:func:`lammps_extract_setting` + function of the C-library interface. Its documentation includes + a list of the supported keywords. + + :param name: name of the setting + :type name: string + :return: value of the setting + :rtype: int + """ + if name: name = name.encode() + else: return None + return int(self.lib.lammps_extract_setting(self.lmp,name)) + + # ------------------------------------------------------------------------- + # extract global info datatype + + def extract_global_datatype(self, name): + """Retrieve global property datatype from LAMMPS + + This is a wrapper around the :cpp:func:`lammps_extract_global_datatype` + function of the C-library interface. Its documentation includes a + list of the supported keywords. + This function returns ``None`` if the keyword is not + recognized. Otherwise it will return a positive integer value that + corresponds to one of the :ref:`data type ` + constants define in the :py:mod:`lammps` module. + + :param name: name of the property + :type name: string + :return: data type of global property, see :ref:`py_datatype_constants` + :rtype: int + """ + if name: name = name.encode() + else: return None + return self.lib.lammps_extract_global_datatype(self.lmp, name) + + # ------------------------------------------------------------------------- + # extract global info + + def extract_global(self, name, dtype=LAMMPS_AUTODETECT): + """Query LAMMPS about global settings of different types. + + This is a wrapper around the :cpp:func:`lammps_extract_global` function + of the C-library interface. Since there are no pointers in Python, this + method will - unlike the C function - return the value or a list of + values. The :cpp:func:`lammps_extract_global` documentation includes a + list of the supported keywords and their data types. + Since Python needs to know the data type to be able to interpret + the result, by default, this function will try to auto-detect the data type + by asking the library. You can also force a specific data type. For that + purpose the :py:mod:`lammps` module contains :ref:`data type ` + constants. This function returns ``None`` if either the keyword is not recognized, + or an invalid data type constant is used. + + :param name: name of the property + :type name: string + :param dtype: data type of the returned data (see :ref:`py_datatype_constants`) + :type dtype: int, optional + :return: value of the property or list of values or None + :rtype: int, float, list, or NoneType + """ + + if dtype == LAMMPS_AUTODETECT: + dtype = self.extract_global_datatype(name) + + # set length of vector for items that are not a scalar + vec_dict = { 'boxlo':3, 'boxhi':3, 'sublo':3, 'subhi':3, + 'sublo_lambda':3, 'subhi_lambda':3, 'periodicity':3 } + if name in vec_dict: + veclen = vec_dict[name] + elif name == 'respa_dt': + veclen = self.extract_global('respa_levels',LAMMPS_INT) + else: + veclen = 1 + + if name: name = name.encode() + else: return None + + if dtype == LAMMPS_INT: + self.lib.lammps_extract_global.restype = POINTER(c_int32) + target_type = int + elif dtype == LAMMPS_INT64: + self.lib.lammps_extract_global.restype = POINTER(c_int64) + target_type = int + elif dtype == LAMMPS_DOUBLE: + self.lib.lammps_extract_global.restype = POINTER(c_double) + target_type = float + elif dtype == LAMMPS_STRING: + self.lib.lammps_extract_global.restype = c_char_p + target_type = str + else: + target_type = None + + ptr = self.lib.lammps_extract_global(self.lmp, name) + if ptr: + if dtype == LAMMPS_STRING: + return ptr.decode('utf-8') + if veclen > 1: + result = [] + for i in range(0,veclen): + result.append(target_type(ptr[i])) + return result + else: return target_type(ptr[0]) + return None + + # ------------------------------------------------------------------------- + # extract per-atom info datatype + + def extract_atom_datatype(self, name): + """Retrieve per-atom property datatype from LAMMPS + + This is a wrapper around the :cpp:func:`lammps_extract_atom_datatype` + function of the C-library interface. Its documentation includes a + list of the supported keywords. + This function returns ``None`` if the keyword is not + recognized. Otherwise it will return an integer value that + corresponds to one of the :ref:`data type ` constants + defined in the :py:mod:`lammps` module. + + :param name: name of the property + :type name: string + :return: data type of per-atom property (see :ref:`py_datatype_constants`) + :rtype: int + """ + if name: name = name.encode() + else: return None + return self.lib.lammps_extract_atom_datatype(self.lmp, name) + + # ------------------------------------------------------------------------- + # extract per-atom info + + def extract_atom(self, name, dtype=LAMMPS_AUTODETECT): + """Retrieve per-atom properties from LAMMPS + + This is a wrapper around the :cpp:func:`lammps_extract_atom` + function of the C-library interface. Its documentation includes a + list of the supported keywords and their data types. + Since Python needs to know the data type to be able to interpret + the result, by default, this function will try to auto-detect the data type + by asking the library. You can also force a specific data type by setting ``dtype`` + to one of the :ref:`data type ` constants defined in the + :py:mod:`lammps` module. + This function returns ``None`` if either the keyword is not + recognized, or an invalid data type constant is used. + + .. note:: + + While the returned arrays of per-atom data are dimensioned + for the range [0:nmax] - as is the underlying storage - + the data is usually only valid for the range of [0:nlocal], + unless the property of interest is also updated for ghost + atoms. In some cases, this depends on a LAMMPS setting, see + for example :doc:`comm_modify vel yes `. + + :param name: name of the property + :type name: string + :param dtype: data type of the returned data (see :ref:`py_datatype_constants`) + :type dtype: int, optional + :return: requested data or ``None`` + :rtype: ctypes.POINTER(ctypes.c_int32), ctypes.POINTER(ctypes.POINTER(ctypes.c_int32)), + ctypes.POINTER(ctypes.c_int64), ctypes.POINTER(ctypes.POINTER(ctypes.c_int64)), + ctypes.POINTER(ctypes.c_double), ctypes.POINTER(ctypes.POINTER(ctypes.c_double)), + or NoneType + """ + if dtype == LAMMPS_AUTODETECT: + dtype = self.extract_atom_datatype(name) + + if name: name = name.encode() + else: return None + + if dtype == LAMMPS_INT: + self.lib.lammps_extract_atom.restype = POINTER(c_int32) + elif dtype == LAMMPS_INT_2D: + self.lib.lammps_extract_atom.restype = POINTER(POINTER(c_int32)) + elif dtype == LAMMPS_DOUBLE: + self.lib.lammps_extract_atom.restype = POINTER(c_double) + elif dtype == LAMMPS_DOUBLE_2D: + self.lib.lammps_extract_atom.restype = POINTER(POINTER(c_double)) + elif dtype == LAMMPS_INT64: + self.lib.lammps_extract_atom.restype = POINTER(c_int64) + elif dtype == LAMMPS_INT64_2D: + self.lib.lammps_extract_atom.restype = POINTER(POINTER(c_int64)) + else: return None + + ptr = self.lib.lammps_extract_atom(self.lmp, name) + if ptr: return ptr + else: return None + + + # ------------------------------------------------------------------------- + + def extract_compute(self,cid,cstyle,ctype): + """Retrieve data from a LAMMPS compute + + This is a wrapper around the :cpp:func:`lammps_extract_compute` + function of the C-library interface. + This function returns ``None`` if either the compute id is not + recognized, or an invalid combination of :ref:`cstyle ` + and :ref:`ctype ` constants is used. The + names and functionality of the constants are the same as for + the corresponding C-library function. For requests to return + a scalar or a size, the value is returned, otherwise a pointer. + + :param cid: compute ID + :type cid: string + :param cstyle: style of the data retrieve (global, atom, or local), see :ref:`py_style_constants` + :type cstyle: int + :param ctype: type or size of the returned data (scalar, vector, or array), see :ref:`py_type_constants` + :type ctype: int + :return: requested data as scalar, pointer to 1d or 2d double array, or None + :rtype: c_double, ctypes.POINTER(c_double), ctypes.POINTER(ctypes.POINTER(c_double)), or NoneType + """ + if cid: cid = cid.encode() + else: return None + + if ctype == LMP_TYPE_SCALAR: + if cstyle == LMP_STYLE_GLOBAL: + self.lib.lammps_extract_compute.restype = POINTER(c_double) + with ExceptionCheck(self): + ptr = self.lib.lammps_extract_compute(self.lmp,cid,cstyle,ctype) + return ptr[0] + elif cstyle == LMP_STYLE_ATOM: + return None + elif cstyle == LMP_STYLE_LOCAL: + self.lib.lammps_extract_compute.restype = POINTER(c_int) + with ExceptionCheck(self): + ptr = self.lib.lammps_extract_compute(self.lmp,cid,cstyle,ctype) + return ptr[0] + + elif ctype == LMP_TYPE_VECTOR: + self.lib.lammps_extract_compute.restype = POINTER(c_double) + with ExceptionCheck(self): + ptr = self.lib.lammps_extract_compute(self.lmp,cid,cstyle,ctype) + return ptr + + elif ctype == LMP_TYPE_ARRAY: + self.lib.lammps_extract_compute.restype = POINTER(POINTER(c_double)) + with ExceptionCheck(self): + ptr = self.lib.lammps_extract_compute(self.lmp,cid,cstyle,ctype) + return ptr + + elif ctype == LMP_SIZE_COLS: + if cstyle == LMP_STYLE_GLOBAL or cstyle == LMP_STYLE_ATOM or cstyle == LMP_STYLE_LOCAL: + self.lib.lammps_extract_compute.restype = POINTER(c_int) + with ExceptionCheck(self): + ptr = self.lib.lammps_extract_compute(self.lmp,cid,cstyle,ctype) + return ptr[0] + + elif ctype == LMP_SIZE_VECTOR or ctype == LMP_SIZE_ROWS: + if cstyle == LMP_STYLE_GLOBAL or cstyle == LMP_STYLE_LOCAL: + self.lib.lammps_extract_compute.restype = POINTER(c_int) + with ExceptionCheck(self): + ptr = self.lib.lammps_extract_compute(self.lmp,cid,cstyle,ctype) + return ptr[0] + + return None + + # ------------------------------------------------------------------------- + # extract fix info + # in case of global data, free memory for 1 double via lammps_free() + # double was allocated by library interface function + + def extract_fix(self,fid,fstyle,ftype,nrow=0,ncol=0): + """Retrieve data from a LAMMPS fix + + This is a wrapper around the :cpp:func:`lammps_extract_fix` + function of the C-library interface. + This function returns ``None`` if either the fix id is not + recognized, or an invalid combination of :ref:`fstyle ` + and :ref:`ftype ` constants is used. The + names and functionality of the constants are the same as for + the corresponding C-library function. For requests to return + a scalar or a size, the value is returned, also when accessing + global vectors or arrays, otherwise a pointer. + + :param fid: fix ID + :type fid: string + :param fstyle: style of the data retrieve (global, atom, or local), see :ref:`py_style_constants` + :type fstyle: int + :param ftype: type or size of the returned data (scalar, vector, or array), see :ref:`py_type_constants` + :type ftype: int + :param nrow: index of global vector element or row index of global array element + :type nrow: int + :param ncol: column index of global array element + :type ncol: int + :return: requested data or None + :rtype: c_double, ctypes.POINTER(c_double), ctypes.POINTER(ctypes.POINTER(c_double)), or NoneType + + """ + if fid: fid = fid.encode() + else: return None + + if fstyle == LMP_STYLE_GLOBAL: + if ftype in (LMP_TYPE_SCALAR, LMP_TYPE_VECTOR, LMP_TYPE_ARRAY): + self.lib.lammps_extract_fix.restype = POINTER(c_double) + with ExceptionCheck(self): + ptr = self.lib.lammps_extract_fix(self.lmp,fid,fstyle,ftype,nrow,ncol) + result = ptr[0] + self.lib.lammps_free(ptr) + return result + elif ftype in (LMP_SIZE_VECTOR, LMP_SIZE_ROWS, LMP_SIZE_COLS): + self.lib.lammps_extract_fix.restype = POINTER(c_int) + with ExceptionCheck(self): + ptr = self.lib.lammps_extract_fix(self.lmp,fid,fstyle,ftype,nrow,ncol) + return ptr[0] + else: + return None + + elif fstyle == LMP_STYLE_ATOM: + if ftype == LMP_TYPE_VECTOR: + self.lib.lammps_extract_fix.restype = POINTER(c_double) + elif ftype == LMP_TYPE_ARRAY: + self.lib.lammps_extract_fix.restype = POINTER(POINTER(c_double)) + elif ftype == LMP_SIZE_COLS: + self.lib.lammps_extract_fix.restype = POINTER(c_int) + else: + return None + with ExceptionCheck(self): + ptr = self.lib.lammps_extract_fix(self.lmp,fid,fstyle,ftype,nrow,ncol) + if ftype == LMP_SIZE_COLS: + return ptr[0] + else: + return ptr + + elif fstyle == LMP_STYLE_LOCAL: + if ftype == LMP_TYPE_VECTOR: + self.lib.lammps_extract_fix.restype = POINTER(c_double) + elif ftype == LMP_TYPE_ARRAY: + self.lib.lammps_extract_fix.restype = POINTER(POINTER(c_double)) + elif ftype in (LMP_TYPE_SCALAR, LMP_SIZE_VECTOR, LMP_SIZE_ROWS, LMP_SIZE_COLS): + self.lib.lammps_extract_fix.restype = POINTER(c_int) + else: + return None + with ExceptionCheck(self): + ptr = self.lib.lammps_extract_fix(self.lmp,fid,fstyle,ftype,nrow,ncol) + if ftype in (LMP_TYPE_VECTOR, LMP_TYPE_ARRAY): + return ptr + else: + return ptr[0] + else: + return None + + # ------------------------------------------------------------------------- + # extract variable info + # free memory for 1 double or 1 vector of doubles via lammps_free() + # for vector, must copy nlocal returned values to local c_double vector + # memory was allocated by library interface function + + def extract_variable(self, name, group=None, vartype=LMP_VAR_EQUAL): + """ Evaluate a LAMMPS variable and return its data + + This function is a wrapper around the function + :cpp:func:`lammps_extract_variable` of the C-library interface, + evaluates variable name and returns a copy of the computed data. + The memory temporarily allocated by the C-interface is deleted + after the data is copied to a Python variable or list. + The variable must be either an equal-style (or equivalent) + variable or an atom-style variable. The variable type has to + provided as ``vartype`` parameter which may be one of two constants: + ``LMP_VAR_EQUAL`` or ``LMP_VAR_ATOM``; it defaults to + equal-style variables. + The group parameter is only used for atom-style variables and + defaults to the group "all" if set to ``None``, which is the default. + + :param name: name of the variable to execute + :type name: string + :param group: name of group for atom-style variable + :type group: string, only for atom-style variables + :param vartype: type of variable, see :ref:`py_vartype_constants` + :type vartype: int + :return: the requested data + :rtype: c_double, (c_double), or NoneType + """ + if name: name = name.encode() + else: return None + if group: group = group.encode() + if vartype == LMP_VAR_EQUAL: + self.lib.lammps_extract_variable.restype = POINTER(c_double) + with ExceptionCheck(self): + ptr = self.lib.lammps_extract_variable(self.lmp,name,group) + if ptr: result = ptr[0] + else: return None + self.lib.lammps_free(ptr) + return result + elif vartype == LMP_VAR_ATOM: + nlocal = self.extract_global("nlocal") + result = (c_double*nlocal)() + self.lib.lammps_extract_variable.restype = POINTER(c_double) + with ExceptionCheck(self): + ptr = self.lib.lammps_extract_variable(self.lmp,name,group) + if ptr: + for i in range(nlocal): result[i] = ptr[i] + self.lib.lammps_free(ptr) + else: return None + return result + return None + + # ------------------------------------------------------------------------- + + def flush_buffers(self): + """Flush output buffers + + This is a wrapper around the :cpp:func:`lammps_flush_buffers` + function of the C-library interface. + """ + self.lib.lammps_flush_buffers(self.lmp) + + # ------------------------------------------------------------------------- + + def set_variable(self,name,value): + """Set a new value for a LAMMPS string style variable + + This is a wrapper around the :cpp:func:`lammps_set_variable` + function of the C-library interface. + + :param name: name of the variable + :type name: string + :param value: new variable value + :type value: any. will be converted to a string + :return: either 0 on success or -1 on failure + :rtype: int + """ + if name: name = name.encode() + else: return -1 + if value: value = str(value).encode() + else: return -1 + with ExceptionCheck(self): + return self.lib.lammps_set_variable(self.lmp,name,value) + + # ------------------------------------------------------------------------- + + # return vector of atom properties gathered across procs + # 3 variants to match src/library.cpp + # name = atom property recognized by LAMMPS in atom->extract() + # dtype = 0 for integer values, 1 for double values + # count = number of per-atom valus, 1 for type or charge, 3 for x or f + # returned data is a 1d vector - doc how it is ordered? + # NOTE: need to insure are converting to/from correct Python type + # e.g. for Python list or NumPy or ctypes + + def gather_atoms(self,name,dtype,count): + if name: name = name.encode() + natoms = self.get_natoms() + with ExceptionCheck(self): + if dtype == 0: + data = ((count*natoms)*c_int)() + self.lib.lammps_gather_atoms(self.lmp,name,dtype,count,data) + elif dtype == 1: + data = ((count*natoms)*c_double)() + self.lib.lammps_gather_atoms(self.lmp,name,dtype,count,data) + else: + return None + return data + + # ------------------------------------------------------------------------- + + def gather_atoms_concat(self,name,dtype,count): + if name: name = name.encode() + natoms = self.get_natoms() + with ExceptionCheck(self): + if dtype == 0: + data = ((count*natoms)*c_int)() + self.lib.lammps_gather_atoms_concat(self.lmp,name,dtype,count,data) + elif dtype == 1: + data = ((count*natoms)*c_double)() + self.lib.lammps_gather_atoms_concat(self.lmp,name,dtype,count,data) + else: + return None + return data + + def gather_atoms_subset(self,name,dtype,count,ndata,ids): + if name: name = name.encode() + with ExceptionCheck(self): + if dtype == 0: + data = ((count*ndata)*c_int)() + self.lib.lammps_gather_atoms_subset(self.lmp,name,dtype,count,ndata,ids,data) + elif dtype == 1: + data = ((count*ndata)*c_double)() + self.lib.lammps_gather_atoms_subset(self.lmp,name,dtype,count,ndata,ids,data) + else: + return None + return data + + # ------------------------------------------------------------------------- + + # scatter vector of atom properties across procs + # 2 variants to match src/library.cpp + # name = atom property recognized by LAMMPS in atom->extract() + # type = 0 for integer values, 1 for double values + # count = number of per-atom valus, 1 for type or charge, 3 for x or f + # assume data is of correct type and length, as created by gather_atoms() + # NOTE: need to insure are converting to/from correct Python type + # e.g. for Python list or NumPy or ctypes + + def scatter_atoms(self,name,dtype,count,data): + if name: name = name.encode() + with ExceptionCheck(self): + self.lib.lammps_scatter_atoms(self.lmp,name,dtype,count,data) + + # ------------------------------------------------------------------------- + + def scatter_atoms_subset(self,name,dtype,count,ndata,ids,data): + if name: name = name.encode() + with ExceptionCheck(self): + self.lib.lammps_scatter_atoms_subset(self.lmp,name,dtype,count,ndata,ids,data) + + + # ------------------------------------------------------------------------- + + def gather_bonds(self): + """Retrieve global list of bonds + + This is a wrapper around the :cpp:func:`lammps_gather_bonds` + function of the C-library interface. + + This function returns a tuple with the number of bonds and a + flat list of ctypes integer values with the bond type, bond atom1, + bond atom2 for each bond. + + .. versionadded:: 28Jul2021 + + :return: a tuple with the number of bonds and a list of c_int or c_long + :rtype: (int, 3*nbonds*c_tagint) + """ + nbonds = self.extract_global("nbonds") + with ExceptionCheck(self): + data = ((3*nbonds)*self.c_tagint)() + self.lib.lammps_gather_bonds(self.lmp,data) + return nbonds,data + + # ------------------------------------------------------------------------- + + # return vector of atom/compute/fix properties gathered across procs + # 3 variants to match src/library.cpp + # name = atom property recognized by LAMMPS in atom->extract() + # type = 0 for integer values, 1 for double values + # count = number of per-atom valus, 1 for type or charge, 3 for x or f + # returned data is a 1d vector - doc how it is ordered? + # NOTE: need to insure are converting to/from correct Python type + # e.g. for Python list or NumPy or ctypes + def gather(self,name,dtype,count): + if name: name = name.encode() + natoms = self.get_natoms() + with ExceptionCheck(self): + if dtype == 0: + data = ((count*natoms)*c_int)() + self.lib.lammps_gather(self.lmp,name,dtype,count,data) + elif dtype == 1: + data = ((count*natoms)*c_double)() + self.lib.lammps_gather(self.lmp,name,dtype,count,data) + else: + return None + return data + + def gather_concat(self,name,dtype,count): + if name: name = name.encode() + natoms = self.get_natoms() + with ExceptionCheck(self): + if dtype == 0: + data = ((count*natoms)*c_int)() + self.lib.lammps_gather_concat(self.lmp,name,dtype,count,data) + elif dtype == 1: + data = ((count*natoms)*c_double)() + self.lib.lammps_gather_concat(self.lmp,name,dtype,count,data) + else: + return None + return data + + def gather_subset(self,name,dtype,count,ndata,ids): + if name: name = name.encode() + with ExceptionCheck(self): + if dtype == 0: + data = ((count*ndata)*c_int)() + self.lib.lammps_gather_subset(self.lmp,name,dtype,count,ndata,ids,data) + elif dtype == 1: + data = ((count*ndata)*c_double)() + self.lib.lammps_gather_subset(self.lmp,name,dtype,count,ndata,ids,data) + else: + return None + return data + + # scatter vector of atom/compute/fix properties across procs + # 2 variants to match src/library.cpp + # name = atom property recognized by LAMMPS in atom->extract() + # type = 0 for integer values, 1 for double values + # count = number of per-atom valus, 1 for type or charge, 3 for x or f + # assume data is of correct type and length, as created by gather_atoms() + # NOTE: need to insure are converting to/from correct Python type + # e.g. for Python list or NumPy or ctypes + + def scatter(self,name,dtype,count,data): + if name: name = name.encode() + with ExceptionCheck(self): + self.lib.lammps_scatter(self.lmp,name,dtype,count,data) + + def scatter_subset(self,name,dtype,count,ndata,ids,data): + if name: name = name.encode() + with ExceptionCheck(self): + self.lib.lammps_scatter_subset(self.lmp,name,dtype,count,ndata,ids,data) + + # ------------------------------------------------------------------------- + + def encode_image_flags(self,ix,iy,iz): + """ convert 3 integers with image flags for x-, y-, and z-direction + into a single integer like it is used internally in LAMMPS + + This method is a wrapper around the :cpp:func:`lammps_encode_image_flags` + function of library interface. + + :param ix: x-direction image flag + :type ix: int + :param iy: y-direction image flag + :type iy: int + :param iz: z-direction image flag + :type iz: int + :return: encoded image flags + :rtype: lammps.c_imageint + """ + return self.lib.lammps_encode_image_flags(ix,iy,iz) + + # ------------------------------------------------------------------------- + + def decode_image_flags(self,image): + """ Convert encoded image flag integer into list of three regular integers. + + This method is a wrapper around the :cpp:func:`lammps_decode_image_flags` + function of library interface. + + :param image: encoded image flags + :type image: lammps.c_imageint + :return: list of three image flags in x-, y-, and z- direction + :rtype: list of 3 int + """ + + flags = (c_int*3)() + self.lib.lammps_decode_image_flags(image,byref(flags)) + + return [int(i) for i in flags] + + # ------------------------------------------------------------------------- + + # create N atoms on all procs + # N = global number of atoms + # id = ID of each atom (optional, can be None) + # type = type of each atom (1 to Ntypes) (required) + # x = coords of each atom as (N,3) array (required) + # v = velocity of each atom as (N,3) array (optional, can be None) + # NOTE: how could we insure are passing correct type to LAMMPS + # e.g. for Python list or NumPy, etc + # ditto for gather_atoms() above + + def create_atoms(self,n,id,type,x,v=None,image=None,shrinkexceed=False): + """ + Create N atoms from list of coordinates and properties + + This function is a wrapper around the :cpp:func:`lammps_create_atoms` + function of the C-library interface, and the behavior is similar except + that the *v*, *image*, and *shrinkexceed* arguments are optional and + default to *None*, *None*, and *False*, respectively. With *None* being + equivalent to a ``NULL`` pointer in C. + + The lists of coordinates, types, atom IDs, velocities, image flags can + be provided in any format that may be converted into the required + internal data types. Also the list may contain more than *N* entries, + but not fewer. In the latter case, the function will return without + attempting to create atoms. You may use the :py:func:`encode_image_flags + ` method to properly combine three integers + with image flags into a single integer. + + :param n: number of atoms for which data is provided + :type n: int + :param id: list of atom IDs with at least n elements or None + :type id: list of lammps.tagint + :param type: list of atom types + :type type: list of int + :param x: list of coordinates for x-, y-, and z (flat list of 3n entries) + :type x: list of float + :param v: list of velocities for x-, y-, and z (flat list of 3n entries) or None (optional) + :type v: list of float + :param image: list of encoded image flags (optional) + :type image: list of lammps.imageint + :param shrinkexceed: whether to expand shrink-wrap boundaries if atoms are outside the box (optional) + :type shrinkexceed: bool + :return: number of atoms created. 0 if insufficient or invalid data + :rtype: int + """ + if id is not None: + id_lmp = (self.c_tagint*n)() + try: + id_lmp[:] = id[0:n] + except ValueError: + return 0 + else: + id_lmp = None + + type_lmp = (c_int*n)() + try: + type_lmp[:] = type[0:n] + except ValueError: + return 0 + + three_n = 3*n + x_lmp = (c_double*three_n)() + try: + x_lmp[:] = x[0:three_n] + except ValueError: + return 0 + + if v is not None: + v_lmp = (c_double*(three_n))() + try: + v_lmp[:] = v[0:three_n] + except ValueError: + return 0 + else: + v_lmp = None + + if image is not None: + img_lmp = (self.c_imageint*n)() + try: + img_lmp[:] = image[0:n] + except ValueError: + return 0 + else: + img_lmp = None + + if shrinkexceed: + se_lmp = 1 + else: + se_lmp = 0 + + self.lib.lammps_create_atoms.argtypes = [c_void_p, c_int, POINTER(self.c_tagint*n), + POINTER(c_int*n), POINTER(c_double*three_n), + POINTER(c_double*three_n), + POINTER(self.c_imageint*n), c_int] + with ExceptionCheck(self): + return self.lib.lammps_create_atoms(self.lmp, n, id_lmp, type_lmp, x_lmp, v_lmp, img_lmp, se_lmp) + + # ------------------------------------------------------------------------- + + @property + def has_mpi_support(self): + """ Report whether the LAMMPS shared library was compiled with a + real MPI library or in serial. + + This is a wrapper around the :cpp:func:`lammps_config_has_mpi_support` + function of the library interface. + + :return: False when compiled with MPI STUBS, otherwise True + :rtype: bool + """ + return self.lib.lammps_config_has_mpi_support() != 0 + + # ------------------------------------------------------------------------- + + @property + def is_running(self): + """ Report whether being called from a function during a run or a minimization + + Various LAMMPS commands must not be called during an ongoing + run or minimization. This property allows to check for that. + This is a wrapper around the :cpp:func:`lammps_is_running` + function of the library interface. + + .. versionadded:: 9Oct2020 + + :return: True when called during a run otherwise false + :rtype: bool + """ + return self.lib.lammps_is_running(self.lmp) == 1 + + # ------------------------------------------------------------------------- + + def force_timeout(self): + """ Trigger an immediate timeout, i.e. a "soft stop" of a run. + + This function allows to cleanly stop an ongoing run or minimization + at the next loop iteration. + This is a wrapper around the :cpp:func:`lammps_force_timeout` + function of the library interface. + + .. versionadded:: 9Oct2020 + """ + self.lib.lammps_force_timeout(self.lmp) + + # ------------------------------------------------------------------------- + + @property + def has_exceptions(self): + """ Report whether the LAMMPS shared library was compiled with C++ + exceptions handling enabled + + This is a wrapper around the :cpp:func:`lammps_config_has_exceptions` + function of the library interface. + + :return: state of C++ exception support + :rtype: bool + """ + return self.lib.lammps_config_has_exceptions() != 0 + + # ------------------------------------------------------------------------- + + @property + def has_gzip_support(self): + """ Report whether the LAMMPS shared library was compiled with support + for reading and writing compressed files through ``gzip``. + + This is a wrapper around the :cpp:func:`lammps_config_has_gzip_support` + function of the library interface. + + :return: state of gzip support + :rtype: bool + """ + return self.lib.lammps_config_has_gzip_support() != 0 + + # ------------------------------------------------------------------------- + + @property + def has_png_support(self): + """ Report whether the LAMMPS shared library was compiled with support + for writing images in PNG format. + + This is a wrapper around the :cpp:func:`lammps_config_has_png_support` + function of the library interface. + + :return: state of PNG support + :rtype: bool + """ + return self.lib.lammps_config_has_png_support() != 0 + + # ------------------------------------------------------------------------- + + @property + def has_jpeg_support(self): + """ Report whether the LAMMPS shared library was compiled with support + for writing images in JPEG format. + + This is a wrapper around the :cpp:func:`lammps_config_has_jpeg_support` + function of the library interface. + + :return: state of JPEG support + :rtype: bool + """ + return self.lib.lammps_config_has_jpeg_support() != 0 + + # ------------------------------------------------------------------------- + + @property + def has_ffmpeg_support(self): + """ State of support for writing movies with ``ffmpeg`` in the LAMMPS shared library + + This is a wrapper around the :cpp:func:`lammps_config_has_ffmpeg_support` + function of the library interface. + + :return: state of ffmpeg support + :rtype: bool + """ + return self.lib.lammps_config_has_ffmpeg_support() != 0 + + # ------------------------------------------------------------------------- + + @property + def accelerator_config(self): + """ Return table with available accelerator configuration settings. + + This is a wrapper around the :cpp:func:`lammps_config_accelerator` + function of the library interface which loops over all known packages + and categories and returns enabled features as a nested dictionary + with all enabled settings as list of strings. + + :return: nested dictionary with all known enabled settings as list of strings + :rtype: dictionary + """ + + result = {} + for p in ['GPU', 'KOKKOS', 'INTEL', 'OPENMP']: + result[p] = {} + c = 'api' + result[p][c] = [] + for s in ['cuda', 'hip', 'phi', 'pthreads', 'opencl', 'openmp', 'serial']: + if self.lib.lammps_config_accelerator(p.encode(),c.encode(),s.encode()): + result[p][c].append(s) + c = 'precision' + result[p][c] = [] + for s in ['double', 'mixed', 'single']: + if self.lib.lammps_config_accelerator(p.encode(),c.encode(),s.encode()): + result[p][c].append(s) + return result + + # ------------------------------------------------------------------------- + + @property + def has_gpu_device(self): + """ Availability of GPU package compatible device + + This is a wrapper around the :cpp:func:`lammps_has_gpu_device` + function of the C library interface. + + :return: True if a GPU package compatible device is present, otherwise False + :rtype: bool + """ + return self.lib.lammps_has_gpu_device() != 0 + + # ------------------------------------------------------------------------- + + def get_gpu_device_info(self): + """Return a string with detailed information about any devices that are + usable by the GPU package. + + This is a wrapper around the :cpp:func:`lammps_get_gpu_device_info` + function of the C-library interface. + + :return: GPU device info string + :rtype: string + """ + + sb = create_string_buffer(8192) + self.lib.lammps_get_gpu_device_info(sb,8192) + return sb.value.decode() + + # ------------------------------------------------------------------------- + + @property + def installed_packages(self): + """ List of the names of enabled packages in the LAMMPS shared library + + This is a wrapper around the functions :cpp:func:`lammps_config_package_count` + and :cpp:func`lammps_config_package_name` of the library interface. + + :return + """ + if self._installed_packages is None: + self._installed_packages = [] + npackages = self.lib.lammps_config_package_count() + sb = create_string_buffer(100) + for idx in range(npackages): + self.lib.lammps_config_package_name(idx, sb, 100) + self._installed_packages.append(sb.value.decode()) + return self._installed_packages + + # ------------------------------------------------------------------------- + + def has_style(self, category, name): + """Returns whether a given style name is available in a given category + + This is a wrapper around the function :cpp:func:`lammps_has_style` + of the library interface. + + :param category: name of category + :type category: string + :param name: name of the style + :type name: string + + :return: true if style is available in given category + :rtype: bool + """ + return self.lib.lammps_has_style(self.lmp, category.encode(), name.encode()) != 0 + + # ------------------------------------------------------------------------- + + def available_styles(self, category): + """Returns a list of styles available for a given category + + This is a wrapper around the functions :cpp:func:`lammps_style_count()` + and :cpp:func:`lammps_style_name()` of the library interface. + + :param category: name of category + :type category: string + + :return: list of style names in given category + :rtype: list + """ + if self._available_styles is None: + self._available_styles = {} + + if category not in self._available_styles: + self._available_styles[category] = [] + with ExceptionCheck(self): + nstyles = self.lib.lammps_style_count(self.lmp, category.encode()) + sb = create_string_buffer(100) + for idx in range(nstyles): + with ExceptionCheck(self): + self.lib.lammps_style_name(self.lmp, category.encode(), idx, sb, 100) + self._available_styles[category].append(sb.value.decode()) + return self._available_styles[category] + + # ------------------------------------------------------------------------- + + def has_id(self, category, name): + """Returns whether a given ID name is available in a given category + + This is a wrapper around the function :cpp:func:`lammps_has_id` + of the library interface. + + .. versionadded:: 9Oct2020 + + :param category: name of category + :type category: string + :param name: name of the ID + :type name: string + + :return: true if ID is available in given category + :rtype: bool + """ + return self.lib.lammps_has_id(self.lmp, category.encode(), name.encode()) != 0 + + # ------------------------------------------------------------------------- + + def available_ids(self, category): + """Returns a list of IDs available for a given category + + This is a wrapper around the functions :cpp:func:`lammps_id_count()` + and :cpp:func:`lammps_id_name()` of the library interface. + + .. versionadded:: 9Oct2020 + + :param category: name of category + :type category: string + + :return: list of id names in given category + :rtype: list + """ + + categories = ['compute','dump','fix','group','molecule','region','variable'] + available_ids = [] + if category in categories: + num = self.lib.lammps_id_count(self.lmp, category.encode()) + sb = create_string_buffer(100) + for idx in range(num): + self.lib.lammps_id_name(self.lmp, category.encode(), idx, sb, 100) + available_ids.append(sb.value.decode()) + return available_ids + + # ------------------------------------------------------------------------- + + def available_plugins(self, category): + """Returns a list of plugins available for a given category + + This is a wrapper around the functions :cpp:func:`lammps_plugin_count()` + and :cpp:func:`lammps_plugin_name()` of the library interface. + + .. versionadded:: 10Mar2021 + + :return: list of style/name pairs of loaded plugins + :rtype: list + """ + + available_plugins = [] + num = self.lib.lammps_plugin_count(self.lmp) + sty = create_string_buffer(100) + nam = create_string_buffer(100) + for idx in range(num): + self.lib.lammps_plugin_name(idx, sty, nam, 100) + available_plugins.append([sty.value.decode(), nam.value.decode()]) + return available_plugins + + # ------------------------------------------------------------------------- + + def set_fix_external_callback(self, fix_id, callback, caller=None): + """Set the callback function for a fix external instance with a given fix ID. + + Optionally also set a reference to the calling object. + + This is a wrapper around the :cpp:func:`lammps_set_fix_external_callback` function + of the C-library interface. However this is set up to call a Python function with + the following arguments. + + .. code-block: python + + def func(object, ntimestep, nlocal, tag, x, f): + + - object is the value of the "caller" argument + - ntimestep is the current timestep + - nlocal is the number of local atoms on the current MPI process + - tag is a 1d NumPy array of integers representing the atom IDs of the local atoms + - x is a 2d NumPy array of doubles of the coordinates of the local atoms + - f is a 2d NumPy array of doubles of the forces on the local atoms that will be added + + .. versionchanged:: 28Jul2021 + + :param fix_id: Fix-ID of a fix external instance + :type: string + :param callback: Python function that will be called from fix external + :type: function + :param caller: reference to some object passed to the callback function + :type: object, optional + """ + import numpy as np + + def callback_wrapper(caller, ntimestep, nlocal, tag_ptr, x_ptr, fext_ptr): + tag = self.numpy.iarray(self.c_tagint, tag_ptr, nlocal, 1) + x = self.numpy.darray(x_ptr, nlocal, 3) + f = self.numpy.darray(fext_ptr, nlocal, 3) + callback(caller, ntimestep, nlocal, tag, x, f) + + cFunc = self.FIX_EXTERNAL_CALLBACK_FUNC(callback_wrapper) + cCaller = caller + + self.callback[fix_id] = { 'function': cFunc, 'caller': caller } + with ExceptionCheck(self): + self.lib.lammps_set_fix_external_callback(self.lmp, fix_id.encode(), cFunc, cCaller) + + # ------------------------------------------------------------------------- + + def fix_external_get_force(self, fix_id): + """Get access to the array with per-atom forces of a fix external instance with a given fix ID. + + This is a wrapper around the :cpp:func:`lammps_fix_external_get_force` function + of the C-library interface. + + .. versionadded:: 28Jul2021 + + :param fix_id: Fix-ID of a fix external instance + :type: string + :return: requested data + :rtype: ctypes.POINTER(ctypes.POINTER(ctypes.double)) + """ + + with ExceptionCheck(self): + return self.lib.lammps_fix_external_get_force(self.lmp, fix_id.encode()) + + # ------------------------------------------------------------------------- + + def fix_external_set_energy_global(self, fix_id, eng): + """Set the global energy contribution for a fix external instance with the given ID. + + This is a wrapper around the :cpp:func:`lammps_fix_external_set_energy_global` function + of the C-library interface. + + .. versionadded:: 28Jul2021 + + :param fix_id: Fix-ID of a fix external instance + :type: string + :param eng: potential energy value to be added by fix external + :type: float + """ + + with ExceptionCheck(self): + return self.lib.lammps_fix_external_set_energy_global(self.lmp, fix_id.encode(), eng) + + # ------------------------------------------------------------------------- + + def fix_external_set_virial_global(self, fix_id, virial): + """Set the global virial contribution for a fix external instance with the given ID. + + This is a wrapper around the :cpp:func:`lammps_fix_external_set_virial_global` function + of the C-library interface. + + .. versionadded:: 28Jul2021 + + :param fix_id: Fix-ID of a fix external instance + :type: string + :param eng: list of 6 floating point numbers with the virial to be added by fix external + :type: float + """ + + cvirial = (6*c_double)(*virial) + with ExceptionCheck(self): + return self.lib.lammps_fix_external_set_virial_global(self.lmp, fix_id.encode(), cvirial) + + # ------------------------------------------------------------------------- + + def fix_external_set_energy_peratom(self, fix_id, eatom): + """Set the per-atom energy contribution for a fix external instance with the given ID. + + This is a wrapper around the :cpp:func:`lammps_fix_external_set_energy_peratom` function + of the C-library interface. + + .. versionadded:: 28Jul2021 + + :param fix_id: Fix-ID of a fix external instance + :type: string + :param eatom: list of potential energy values for local atoms to be added by fix external + :type: float + """ + + nlocal = self.extract_setting('nlocal') + if len(eatom) < nlocal: + raise Exception('per-atom energy list length must be at least nlocal') + ceatom = (nlocal*c_double)(*eatom) + with ExceptionCheck(self): + return self.lib.lammps_fix_external_set_energy_peratom(self.lmp, fix_id.encode(), ceatom) + + # ------------------------------------------------------------------------- + + def fix_external_set_virial_peratom(self, fix_id, vatom): + """Set the per-atom virial contribution for a fix external instance with the given ID. + + This is a wrapper around the :cpp:func:`lammps_fix_external_set_virial_peratom` function + of the C-library interface. + + .. versionadded:: 28Jul2021 + + :param fix_id: Fix-ID of a fix external instance + :type: string + :param vatom: list of natoms lists with 6 floating point numbers to be added by fix external + :type: float + """ + + # copy virial data to C compatible buffer + nlocal = self.extract_setting('nlocal') + if len(vatom) < nlocal: + raise Exception('per-atom virial first dimension must be at least nlocal') + if len(vatom[0]) != 6: + raise Exception('per-atom virial second dimension must be 6') + vbuf = (c_double * 6) + vptr = POINTER(c_double) + c_virial = (vptr * nlocal)() + for i in range(nlocal): + c_virial[i] = vbuf() + for j in range(6): + c_virial[i][j] = vatom[i][j] + + with ExceptionCheck(self): + return self.lib.lammps_fix_external_set_virial_peratom(self.lmp, fix_id.encode(), c_virial) + + # ------------------------------------------------------------------------- + def fix_external_set_vector_length(self, fix_id, length): + """Set the vector length for a global vector stored with fix external for analysis + + This is a wrapper around the :cpp:func:`lammps_fix_external_set_vector_length` function + of the C-library interface. + + .. versionadded:: 28Jul2021 + + :param fix_id: Fix-ID of a fix external instance + :type: string + :param length: length of the global vector + :type: int + """ + + with ExceptionCheck(self): + return self.lib.lammps_fix_external_set_vector_length(self.lmp, fix_id.encode(), length) + + # ------------------------------------------------------------------------- + def fix_external_set_vector(self, fix_id, idx, val): + """Store a global vector value for a fix external instance with the given ID. + + This is a wrapper around the :cpp:func:`lammps_fix_external_set_vector` function + of the C-library interface. + + .. versionadded:: 28Jul2021 + + :param fix_id: Fix-ID of a fix external instance + :type: string + :param idx: 1-based index of the value in the global vector + :type: int + :param val: value to be stored in the global vector + :type: float + """ + + with ExceptionCheck(self): + return self.lib.lammps_fix_external_set_vector(self.lmp, fix_id.encode(), idx, val) + + # ------------------------------------------------------------------------- + + def get_neighlist(self, idx): + """Returns an instance of :class:`NeighList` which wraps access to the neighbor list with the given index + + See :py:meth:`lammps.numpy.get_neighlist() ` if you want to use + NumPy arrays instead of ``c_int`` pointers. + + :param idx: index of neighbor list + :type idx: int + :return: an instance of :class:`NeighList` wrapping access to neighbor list data + :rtype: NeighList + """ + if idx < 0: + return None + return NeighList(self, idx) + + # ------------------------------------------------------------------------- + + def get_neighlist_size(self, idx): + """Return the number of elements in neighbor list with the given index + + :param idx: neighbor list index + :type idx: int + :return: number of elements in neighbor list with index idx + :rtype: int + """ + return self.lib.lammps_neighlist_num_elements(self.lmp, idx) + + # ------------------------------------------------------------------------- + + def get_neighlist_element_neighbors(self, idx, element): + """Return data of neighbor list entry + + :param element: neighbor list index + :type element: int + :param element: neighbor list element index + :type element: int + :return: tuple with atom local index, number of neighbors and array of neighbor local atom indices + :rtype: (int, int, POINTER(c_int)) + """ + c_iatom = c_int() + c_numneigh = c_int() + c_neighbors = POINTER(c_int)() + self.lib.lammps_neighlist_element_neighbors(self.lmp, idx, element, byref(c_iatom), byref(c_numneigh), byref(c_neighbors)) + return c_iatom.value, c_numneigh.value, c_neighbors + + # ------------------------------------------------------------------------- + + def find_pair_neighlist(self, style, exact=True, nsub=0, reqid=0): + """Find neighbor list index of pair style neighbor list + + Search for a neighbor list requested by a pair style instance that + matches "style". If exact is True, the pair style name must match + exactly. If exact is False, the pair style name is matched against + "style" as regular expression or sub-string. If the pair style is a + hybrid pair style, the style is instead matched against the hybrid + sub-styles. If the same pair style is used as sub-style multiple + types, you must set nsub to a value n > 0 which indicates the nth + instance of that sub-style to be used (same as for the pair_coeff + command). The default value of 0 will fail to match in that case. + + Once the pair style instance has been identified, it may have + requested multiple neighbor lists. Those are uniquely identified by + a request ID > 0 as set by the pair style. Otherwise the request + ID is 0. + + :param style: name of pair style that should be searched for + :type style: string + :param exact: controls whether style should match exactly or only must be contained in pair style name, defaults to True + :type exact: bool, optional + :param nsub: match nsub-th hybrid sub-style, defaults to 0 + :type nsub: int, optional + :param reqid: list request id, > 0 in case there are more than one, defaults to 0 + :type reqid: int, optional + :return: neighbor list index if found, otherwise -1 + :rtype: int + + """ + style = style.encode() + exact = int(exact) + idx = self.lib.lammps_find_pair_neighlist(self.lmp, style, exact, nsub, reqid) + return idx + + # ------------------------------------------------------------------------- + + def find_fix_neighlist(self, fixid, reqid=0): + """Find neighbor list index of fix neighbor list + + The fix instance requesting the neighbor list is uniquely identified + by the fix ID. In case the fix has requested multiple neighbor + lists, those are uniquely identified by a request ID > 0 as set by + the fix. Otherwise the request ID is 0 (the default). + + :param fixid: name of fix + :type fixid: string + :param reqid: id of neighbor list request, in case there are more than one request, defaults to 0 + :type reqid: int, optional + :return: neighbor list index if found, otherwise -1 + :rtype: int + + """ + fixid = fixid.encode() + idx = self.lib.lammps_find_fix_neighlist(self.lmp, fixid, reqid) + return idx + + # ------------------------------------------------------------------------- + + def find_compute_neighlist(self, computeid, reqid=0): + """Find neighbor list index of compute neighbor list + + The compute instance requesting the neighbor list is uniquely + identified by the compute ID. In case the compute has requested + multiple neighbor lists, those are uniquely identified by a request + ID > 0 as set by the compute. Otherwise the request ID is 0 (the + default). + + :param computeid: name of compute + :type computeid: string + :param reqid: index of neighbor list request, in case there are more than one request, defaults to 0 + :type reqid: int, optional + :return: neighbor list index if found, otherwise -1 + :rtype: int + + """ + computeid = computeid.encode() + idx = self.lib.lammps_find_compute_neighlist(self.lmp, computeid, reqid) + return idx diff --git a/python/lammps/data.py b/python/lammps/data.py new file mode 100644 index 0000000000..731a8c514a --- /dev/null +++ b/python/lammps/data.py @@ -0,0 +1,92 @@ +# ---------------------------------------------------------------------- +# LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator +# https://www.lammps.org/ Sandia National Laboratories +# Steve Plimpton, sjplimp@sandia.gov +# +# Copyright (2003) Sandia Corporation. Under the terms of Contract +# DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains +# certain rights in this software. This software is distributed under +# the GNU General Public License. +# +# See the README file in the top-level LAMMPS directory. +# ------------------------------------------------------------------------- + +################################################################################ +# LAMMPS data structures +# Written by Richard Berger +################################################################################ + +class NeighList(object): + """This is a wrapper class that exposes the contents of a neighbor list. + + It can be used like a regular Python list. Each element is a tuple of: + + * the atom local index + * its number of neighbors + * and a pointer to an c_int array containing local atom indices of its + neighbors + + Internally it uses the lower-level LAMMPS C-library interface. + + :param lmp: reference to instance of :py:class:`lammps` + :type lmp: lammps + :param idx: neighbor list index + :type idx: int + """ + def __init__(self, lmp, idx): + self.lmp = lmp + self.idx = idx + + def __str__(self): + return "Neighbor List ({} atoms)".format(self.size) + + def __repr__(self): + return self.__str__() + + @property + def size(self): + """ + :return: number of elements in neighbor list + """ + return self.lmp.get_neighlist_size(self.idx) + + def get(self, element): + """ + Access a specific neighbor list entry. "element" must be a number from 0 to the size-1 of the list + + :return: tuple with atom local index, number of neighbors and ctypes pointer to neighbor's local atom indices + :rtype: (int, int, ctypes.POINTER(c_int)) + """ + iatom, numneigh, neighbors = self.lmp.get_neighlist_element_neighbors(self.idx, element) + return iatom, numneigh, neighbors + + # the methods below implement the iterator interface, so NeighList can be used like a regular Python list + + def __getitem__(self, element): + return self.get(element) + + def __len__(self): + return self.size + + def __iter__(self): + inum = self.size + + for ii in range(inum): + yield self.get(ii) + + def find(self, iatom): + """ + Find the neighbor list for a specific (local) atom iatom. + If there is no list for iatom, (-1, None) is returned. + + :return: tuple with number of neighbors and ctypes pointer to neighbor's local atom indices + :rtype: (int, ctypes.POINTER(c_int)) + """ + + inum = self.size + for ii in range(inum): + idx, numneigh, neighbors = self.get(ii) + if idx == iatom: + return numneigh, neighbors + + return -1, None diff --git a/python/lammps/formats.py b/python/lammps/formats.py new file mode 100644 index 0000000000..b7c267466f --- /dev/null +++ b/python/lammps/formats.py @@ -0,0 +1,227 @@ +# ---------------------------------------------------------------------- +# LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator +# https://www.lammps.org/ Sandia National Laboratories +# Steve Plimpton, sjplimp@sandia.gov +# +# Copyright (2003) Sandia Corporation. Under the terms of Contract +# DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains +# certain rights in this software. This software is distributed under +# the GNU General Public License. +# +# See the README file in the top-level LAMMPS directory. +# ------------------------------------------------------------------------- + +################################################################################ +# LAMMPS output formats +# Written by Richard Berger +# and Axel Kohlmeyer +################################################################################ + +import re + +has_yaml = False +try: + import yaml + has_yaml = True + try: + from yaml import CSafeLoader as Loader + except ImportError: + from yaml import SafeLoader as Loader +except ImportError: + # ignore here, raise an exception when trying to parse yaml instead + pass + +class LogFile: + """Reads LAMMPS log files and extracts the thermo information + + It supports the line, multi, and yaml thermo output styles. + + :param filename: path to log file + :type filename: str + + :ivar runs: List of LAMMPS runs in log file. Each run is a dictionary with + thermo fields as keys, storing the values over time + :ivar errors: List of error lines in log file + """ + + STYLE_DEFAULT = 0 + STYLE_MULTI = 1 + STYLE_YAML = 2 + + def __init__(self, filename): + alpha = re.compile(r'[a-df-zA-DF-Z]') # except e or E for floating-point numbers + kvpairs = re.compile(r'([a-zA-Z_0-9]+)\s+=\s*([0-9\.eE\-]+)') + style = LogFile.STYLE_DEFAULT + yamllog = "" + self.runs = [] + self.errors = [] + with open(filename, 'rt') as f: + in_thermo = False + in_data_section = False + for line in f: + if "ERROR" in line or "exited on signal" in line: + self.errors.append(line) + + elif re.match(r'^ *Step ', line): + in_thermo = True + in_data_section = True + keys = line.split() + current_run = {} + for k in keys: + current_run[k] = [] + + elif re.match(r'^(keywords:.*$|data:$|---$| - \[.*\]$)', line): + if not has_yaml: + raise Exception('Cannot process YAML format logs without the PyYAML Python module') + style = LogFile.STYLE_YAML + yamllog += line; + current_run = {} + + elif re.match(r'^\.\.\.$', line): + thermo = yaml.load(yamllog, Loader=Loader) + for k in thermo['keywords']: + current_run[k] = [] + for step in thermo['data']: + icol = 0 + for k in thermo['keywords']: + current_run[k].append(step[icol]) + icol += 1 + self.runs.append(current_run) + yamllog = "" + + elif re.match(r'^------* Step ', line): + if not in_thermo: + current_run = {'Step': [], 'CPU': []} + in_thermo = True + in_data_section = True + style = LogFile.STYLE_MULTI + str_step, str_cpu = line.strip('-\n').split('-----') + step = float(str_step.split()[1]) + cpu = float(str_cpu.split('=')[1].split()[0]) + current_run["Step"].append(step) + current_run["CPU"].append(cpu) + + elif line.startswith('Loop time of'): + in_thermo = False + if style != LogFile.STYLE_YAML: + self.runs.append(current_run) + + elif in_thermo and in_data_section: + if style == LogFile.STYLE_DEFAULT: + if alpha.search(line): + continue + for k, v in zip(keys, map(float, line.split())): + current_run[k].append(v) + + elif style == LogFile.STYLE_MULTI: + if '=' not in line: + in_data_section = False + continue + for k,v in kvpairs.findall(line): + if k not in current_run: + current_run[k] = [float(v)] + else: + current_run[k].append(float(v)) + +class AvgChunkFile: + """Reads files generated by fix ave/chunk + + :param filename: path to ave/chunk file + :type filename: str + + :ivar timesteps: List of timesteps stored in file + :ivar total_count: total count over time + :ivar chunks: List of chunks. Each chunk is a dictionary containing its ID, the coordinates, and the averaged quantities + """ + def __init__(self, filename): + with open(filename, 'rt') as f: + timestep = None + chunks_read = 0 + + self.timesteps = [] + self.total_count = [] + self.chunks = [] + + for lineno, line in enumerate(f): + if lineno == 0: + if not line.startswith("# Chunk-averaged data for fix"): + raise Exception("Chunk data reader only supports default avg/chunk headers!") + parts = line.split() + self.fix_name = parts[5] + self.group_name = parts[8] + continue + elif lineno == 1: + if not line.startswith("# Timestep Number-of-chunks Total-count"): + raise Exception("Chunk data reader only supports default avg/chunk headers!") + continue + elif lineno == 2: + if not line.startswith("#"): + raise Exception("Chunk data reader only supports default avg/chunk headers!") + columns = line.split()[1:] + ndim = line.count("Coord") + compress = 'OrigID' in line + if ndim > 0: + coord_start = columns.index("Coord1") + coord_end = columns.index("Coord%d" % ndim) + ncount_start = coord_end + 1 + data_start = ncount_start + 1 + else: + coord_start = None + coord_end = None + ncount_start = 2 + data_start = 3 + continue + + parts = line.split() + + if timestep is None: + timestep = int(parts[0]) + num_chunks = int(parts[1]) + total_count = float(parts[2]) + + self.timesteps.append(timestep) + self.total_count.append(total_count) + + for i in range(num_chunks): + self.chunks.append({ + 'coord' : [], + 'ncount' : [] + }) + elif chunks_read < num_chunks: + chunk = int(parts[0]) + ncount = float(parts[ncount_start]) + + if compress: + chunk_id = int(parts[1]) + else: + chunk_id = chunk + + current = self.chunks[chunk_id - 1] + current['id'] = chunk_id + current['ncount'].append(ncount) + + if ndim > 0: + coord = tuple(map(float, parts[coord_start:coord_end+1])) + current['coord'].append(coord) + + for i, data_column in list(enumerate(columns))[data_start:]: + value = float(parts[i]) + + if data_column in current: + current[data_column].append(value) + else: + current[data_column] = [value] + + chunks_read += 1 + assert chunk == chunks_read + else: + # do not support changing number of chunks + if not (num_chunks == int(parts[1])): + raise Exception("Currently, changing numbers of chunks are not supported.") + + timestep = int(parts[0]) + total_count = float(parts[2]) + chunks_read = 0 + + self.timesteps.append(timestep) + self.total_count.append(total_count) diff --git a/python/lammps/mliap/__init__.py b/python/lammps/mliap/__init__.py new file mode 100644 index 0000000000..57fe97d803 --- /dev/null +++ b/python/lammps/mliap/__init__.py @@ -0,0 +1,20 @@ + +# Check compatiblity of this build with the python shared library. +# If this fails, lammps will segfault because its library will +# try to improperly start up a new interpreter. +import sysconfig +import ctypes +library = sysconfig.get_config_vars('INSTSONAME')[0] +try: + pylib = ctypes.CDLL(library) +except OSError as e: + if pylib.endswith(".a"): + pylib.strip(".a") + ".so" + pylib = ctypes.CDLL(library) + else: + raise e +if not pylib.Py_IsInitialized(): + raise RuntimeError("This interpreter is not compatible with python-based mliap for LAMMPS.") +del sysconfig, ctypes, library, pylib + +from .loader import load_model, activate_mliappy diff --git a/python/lammps/mliap/loader.py b/python/lammps/mliap/loader.py new file mode 100644 index 0000000000..dff791bfc1 --- /dev/null +++ b/python/lammps/mliap/loader.py @@ -0,0 +1,52 @@ +# ---------------------------------------------------------------------- +# LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator +# https://www.lammps.org/ Sandia National Laboratories +# Steve Plimpton, sjplimp@sandia.gov +# +# Copyright (2003) Sandia Corporation. Under the terms of Contract +# DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains +# certain rights in this software. This software is distributed under +# the GNU General Public License. +# +# See the README file in the top-level LAMMPS directory. +# ------------------------------------------------------------------------- + +# ---------------------------------------------------------------------- +# Contributing author: Nicholas Lubbers (LANL) +# ------------------------------------------------------------------------- + + +import sys +import importlib.util +import importlib.machinery + +def activate_mliappy(lmp): + try: + # Begin Importlib magic to find the embedded python module + # This is needed because the filename for liblammps does not + # match the spec for normal python modules, wherein + # file names match with PyInit function names. + # Also, python normally doesn't look for extensions besides '.so' + # We fix both of these problems by providing an explict + # path to the extension module 'mliap_model_python_couple' in + + path = lmp.lib._name + loader = importlib.machinery.ExtensionFileLoader('mliap_model_python_couple', path) + spec = importlib.util.spec_from_loader('mliap_model_python_couple', loader) + module = importlib.util.module_from_spec(spec) + sys.modules['mliap_model_python_couple'] = module + spec.loader.exec_module(module) + # End Importlib magic to find the embedded python module + + except Exception as ee: + raise ImportError("Could not load ML-IAP python coupling module.") from ee + +def load_model(model): + try: + import mliap_model_python_couple + except ImportError as ie: + raise ImportError("ML-IAP python module must be activated before loading\n" + "the pair style. Call lammps.mliap.activate_mliappy(lmp)." + ) from ie + mliap_model_python_couple.load_from_python(model) + diff --git a/python/lammps/mliap/pytorch.py b/python/lammps/mliap/pytorch.py new file mode 100644 index 0000000000..9aa2da80f4 --- /dev/null +++ b/python/lammps/mliap/pytorch.py @@ -0,0 +1,326 @@ +# ---------------------------------------------------------------------- +# LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator +# https://www.lammps.org/ Sandia National Laboratories +# Steve Plimpton, sjplimp@sandia.gov +# +# Copyright (2003) Sandia Corporation. Under the terms of Contract +# DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains +# certain rights in this software. This software is distributed under +# the GNU General Public License. +# +# See the README file in the top-level LAMMPS directory. +# ------------------------------------------------------------------------- + +# ---------------------------------------------------------------------- +# Contributing author: Nicholas Lubbers (LANL) +# ------------------------------------------------------------------------- + +import numpy as np +import torch + +def calc_n_params(model): + """ + Returns the sum of two decimal numbers in binary digits. + + Parameters: + model (torch.nn.Module): Network model that maps descriptors to a per atom attribute + + Returns: + n_params (int): Number of NN model parameters + """ + return sum(p.nelement() for p in model.parameters()) + +class TorchWrapper(torch.nn.Module): + """ + A class to wrap Modules to ensure lammps mliap compatability. + + ... + + Attributes + ---------- + model : torch.nn.Module + Network model that maps descriptors to a per atom attribute + + device : torch.nn.Module (None) + Accelerator device + + dtype : torch.dtype (torch.float64) + Dtype to use on device + + n_params : torch.nn.Module (None) + Number of NN model parameters + + n_descriptors : int + Max number of per atom descriptors + + n_elements : int + Max number of elements + + + Methods + ------- + forward(descriptors, elems): + Feeds descriptors to network model to produce per atom energies and forces. + """ + + def __init__(self, model, n_descriptors, n_elements, n_params=None, device=None, dtype=torch.float64): + """ + Constructs all the necessary attributes for the network module. + + Parameters + ---------- + model : torch.nn.Module + Network model that maps descriptors to a per atom attribute + + n_descriptors : int + Max number of per atom descriptors + + n_elements : int + Max number of elements + + n_params : torch.nn.Module (None) + Number of NN model parameters + + device : torch.nn.Module (None) + Accelerator device + + dtype : torch.dtype (torch.float64) + Dtype to use on device + """ + + super().__init__() + + self.model = model + self.device = device + self.dtype = dtype + + # Put model on device and convert to dtype + self.to(self.dtype) + self.to(self.device) + + if n_params is None: + n_params = calc_n_params(model) + + self.n_params = n_params + self.n_descriptors = n_descriptors + self.n_elements = n_elements + + def forward(self, elems, descriptors, beta, energy): + """ + Takes element types and descriptors calculated via lammps and + calculates the per atom energies and forces. + + Parameters + ---------- + elems : numpy.array + Per atom element types + + descriptors : numpy.array + Per atom descriptors + + beta : numpy.array + Expired beta array to be filled with new betas + + energy : numpy.array + Expired per atom energy array to be filled with new per atom energy + (Note: This is a pointer to the lammps per atom energies) + + + Returns + ------- + None + """ + + descriptors = torch.from_numpy(descriptors).to(dtype=self.dtype, device=self.device).requires_grad_(True) + elems = torch.from_numpy(elems).to(dtype=torch.long, device=self.device) - 1 + + with torch.autograd.enable_grad(): + + energy_nn = self.model(descriptors, elems) + if energy_nn.ndim > 1: + energy_nn = energy_nn.flatten() + + beta_nn = torch.autograd.grad(energy_nn.sum(), descriptors)[0] + + beta[:] = beta_nn.detach().cpu().numpy().astype(np.float64) + energy[:] = energy_nn.detach().cpu().numpy().astype(np.float64) + + +class IgnoreElems(torch.nn.Module): + """ + A class to represent a NN model agnostic of element typing. + + ... + + Attributes + ---------- + subnet : torch.nn.Module + Network model that maps descriptors to a per atom attribute + + Methods + ------- + forward(descriptors, elems): + Feeds descriptors to network model + """ + + def __init__(self, subnet): + """ + Constructs all the necessary attributes for the network module. + + Parameters + ---------- + subnet : torch.nn.Module + Network model that maps descriptors to a per atom attribute + """ + + super().__init__() + self.subnet = subnet + + def forward(self, descriptors, elems): + """ + Feeds descriptors to network model + + Parameters + ---------- + descriptors : torch.tensor + Per atom descriptors + + elems : torch.tensor + Per atom element types + + Returns + ------- + self.subnet(descriptors) : torch.tensor + Per atom attribute computed by the network model + """ + + return self.subnet(descriptors) + + +class UnpackElems(torch.nn.Module): + """ + A class to represent a NN model pseudo-agnostic of element typing for + systems with multiple element typings. + + ... + + Attributes + ---------- + subnet : torch.nn.Module + Network model that maps descriptors to a per atom attribute + + n_types : int + Number of atom types used in training the NN model. + + Methods + ------- + forward(descriptors, elems): + Feeds descriptors to network model after adding zeros into + descriptor columns relating to different atom types + """ + + def __init__(self, subnet, n_types): + """ + Constructs all the necessary attributes for the network module. + + Parameters + ---------- + subnet : torch.nn.Module + Network model that maps descriptors to a per atom attribute. + + n_types : int + Number of atom types used in training the NN model. + """ + super().__init__() + self.subnet = subnet + self.n_types = n_types + + def forward(self, descriptors, elems): + """ + Feeds descriptors to network model after adding zeros into + descriptor columns relating to different atom types + + Parameters + ---------- + descriptors : torch.tensor + Per atom descriptors + + elems : torch.tensor + Per atom element types + + Returns + ------- + self.subnet(descriptors) : torch.tensor + Per atom attribute computed by the network model + """ + + unpacked_descriptors = torch.zeros(elems.shape[0], self.n_types, descriptors.shape[1], dtype=torch.float64) + for i, ind in enumerate(elems): + unpacked_descriptors[i, ind, :] = descriptors[i] + return self.subnet(torch.reshape(unpacked_descriptors, (elems.shape[0], -1)), elems) + + +class ElemwiseModels(torch.nn.Module): + """ + A class to represent a NN model dependent on element typing. + + ... + + Attributes + ---------- + subnets : list of torch.nn.Modules + Per element type network models that maps per element type + descriptors to a per atom attribute. + + n_types : int + Number of atom types used in training the NN model. + + Methods + ------- + forward(descriptors, elems): + Feeds descriptors to network model after adding zeros into + descriptor columns relating to different atom types + """ + + def __init__(self, subnets, n_types): + """ + Constructs all the necessary attributes for the network module. + + Parameters + ---------- + subnets : list of torch.nn.Modules + Per element type network models that maps per element + type descriptors to a per atom attribute. + + n_types : int + Number of atom types used in training the NN model. + """ + + super().__init__() + self.subnets = subnets + self.n_types = n_types + + def forward(self, descriptors, elems): + """ + Feeds descriptors to network model after adding zeros into + descriptor columns relating to different atom types + + Parameters + ---------- + descriptors : torch.tensor + Per atom descriptors + + elems : torch.tensor + Per atom element types + + Returns + ------- + self.subnets(descriptors) : torch.tensor + Per atom attribute computed by the network model + """ + + per_atom_attributes = torch.zeros(elems.size[0]) + given_elems, elem_indices = torch.unique(elems, return_inverse=True) + for i, elem in enumerate(given_elems): + per_atom_attribute[elem_indices == i] = self.subnets[elem](descriptors[elem_indices == i]) + return per_atom_attributes diff --git a/python/lammps/numpy_wrapper.py b/python/lammps/numpy_wrapper.py new file mode 100644 index 0000000000..ce0cb35e47 --- /dev/null +++ b/python/lammps/numpy_wrapper.py @@ -0,0 +1,483 @@ +# ---------------------------------------------------------------------- +# LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator +# https://www.lammps.org/ Sandia National Laboratories +# Steve Plimpton, sjplimp@sandia.gov +# +# Copyright (2003) Sandia Corporation. Under the terms of Contract +# DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains +# certain rights in this software. This software is distributed under +# the GNU General Public License. +# +# See the README file in the top-level LAMMPS directory. +# ------------------------------------------------------------------------- + +################################################################################ +# NumPy additions +# Written by Richard Berger +################################################################################ + +import warnings +from ctypes import POINTER, c_void_p, c_char_p, c_double, c_int, c_int32, c_int64, cast + + +from .constants import * # lgtm [py/polluting-import] +from .data import NeighList + + +class numpy_wrapper: + """lammps API NumPy Wrapper + + This is a wrapper class that provides additional methods on top of an + existing :py:class:`lammps` instance. The methods transform raw ctypes + pointers into NumPy arrays, which give direct access to the + original data while protecting against out-of-bounds accesses. + + There is no need to explicitly instantiate this class. Each instance + of :py:class:`lammps` has a :py:attr:`numpy ` property + that returns an instance. + + :param lmp: instance of the :py:class:`lammps` class + :type lmp: lammps + """ + def __init__(self, lmp): + self.lmp = lmp + + # ------------------------------------------------------------------------- + + def _ctype_to_numpy_int(self, ctype_int): + import numpy as np + if ctype_int == c_int32: + return np.int32 + elif ctype_int == c_int64: + return np.int64 + return np.intc + + # ------------------------------------------------------------------------- + + def extract_atom(self, name, dtype=LAMMPS_AUTODETECT, nelem=LAMMPS_AUTODETECT, dim=LAMMPS_AUTODETECT): + """Retrieve per-atom properties from LAMMPS as NumPy arrays + + This is a wrapper around the :py:meth:`lammps.extract_atom()` method. + It behaves the same as the original method, but returns NumPy arrays + instead of ``ctypes`` pointers. + + .. note:: + + While the returned arrays of per-atom data are dimensioned + for the range [0:nmax] - as is the underlying storage - + the data is usually only valid for the range of [0:nlocal], + unless the property of interest is also updated for ghost + atoms. In some cases, this depends on a LAMMPS setting, see + for example :doc:`comm_modify vel yes `. + + :param name: name of the property + :type name: string + :param dtype: type of the returned data (see :ref:`py_datatype_constants`) + :type dtype: int, optional + :param nelem: number of elements in array + :type nelem: int, optional + :param dim: dimension of each element + :type dim: int, optional + :return: requested data as NumPy array with direct access to C data or None + :rtype: numpy.array or NoneType + """ + if dtype == LAMMPS_AUTODETECT: + dtype = self.lmp.extract_atom_datatype(name) + + if nelem == LAMMPS_AUTODETECT: + if name == "mass": + nelem = self.lmp.extract_global("ntypes") + 1 + else: + nelem = self.lmp.extract_global("nlocal") + if dim == LAMMPS_AUTODETECT: + if dtype in (LAMMPS_INT_2D, LAMMPS_DOUBLE_2D, LAMMPS_INT64_2D): + # TODO add other fields + if name in ("x", "v", "f", "x0","omega", "angmom", "torque", "csforce", "vforce", "vest"): + dim = 3 + elif name == "smd_data_9": + dim = 9 + elif name == "smd_stress": + dim = 6 + else: + dim = 2 + else: + dim = 1 + + raw_ptr = self.lmp.extract_atom(name, dtype) + + if dtype in (LAMMPS_DOUBLE, LAMMPS_DOUBLE_2D): + return self.darray(raw_ptr, nelem, dim) + elif dtype in (LAMMPS_INT, LAMMPS_INT_2D): + return self.iarray(c_int32, raw_ptr, nelem, dim) + elif dtype in (LAMMPS_INT64, LAMMPS_INT64_2D): + return self.iarray(c_int64, raw_ptr, nelem, dim) + return raw_ptr + + # ------------------------------------------------------------------------- + + def extract_atom_iarray(self, name, nelem, dim=1): + warnings.warn("deprecated, use extract_atom instead", DeprecationWarning) + + if name in ['id', 'molecule']: + c_int_type = self.lmp.c_tagint + elif name in ['image']: + c_int_type = self.lmp.c_imageint + else: + c_int_type = c_int + + if dim == 1: + raw_ptr = self.lmp.extract_atom(name, LAMMPS_INT) + else: + raw_ptr = self.lmp.extract_atom(name, LAMMPS_INT_2D) + + return self.iarray(c_int_type, raw_ptr, nelem, dim) + + # ------------------------------------------------------------------------- + + def extract_atom_darray(self, name, nelem, dim=1): + warnings.warn("deprecated, use extract_atom instead", DeprecationWarning) + + if dim == 1: + raw_ptr = self.lmp.extract_atom(name, LAMMPS_DOUBLE) + else: + raw_ptr = self.lmp.extract_atom(name, LAMMPS_DOUBLE_2D) + + return self.darray(raw_ptr, nelem, dim) + + # ------------------------------------------------------------------------- + + def extract_compute(self, cid, cstyle, ctype): + """Retrieve data from a LAMMPS compute + + This is a wrapper around the + :py:meth:`lammps.extract_compute() ` method. + It behaves the same as the original method, but returns NumPy arrays + instead of ``ctypes`` pointers. + + :param cid: compute ID + :type cid: string + :param cstyle: style of the data retrieve (global, atom, or local), see :ref:`py_style_constants` + :type cstyle: int + :param ctype: type of the returned data (scalar, vector, or array), see :ref:`py_type_constants` + :type ctype: int + :return: requested data either as float, as NumPy array with direct access to C data, or None + :rtype: float, numpy.array, or NoneType + """ + value = self.lmp.extract_compute(cid, cstyle, ctype) + + if cstyle == LMP_STYLE_GLOBAL: + if ctype == LMP_TYPE_VECTOR: + nrows = self.lmp.extract_compute(cid, cstyle, LMP_SIZE_VECTOR) + return self.darray(value, nrows) + elif ctype == LMP_TYPE_ARRAY: + nrows = self.lmp.extract_compute(cid, cstyle, LMP_SIZE_ROWS) + ncols = self.lmp.extract_compute(cid, cstyle, LMP_SIZE_COLS) + return self.darray(value, nrows, ncols) + elif cstyle == LMP_STYLE_LOCAL: + nrows = self.lmp.extract_compute(cid, cstyle, LMP_SIZE_ROWS) + ncols = self.lmp.extract_compute(cid, cstyle, LMP_SIZE_COLS) + if ncols == 0: + return self.darray(value, nrows) + else: + return self.darray(value, nrows, ncols) + elif cstyle == LMP_STYLE_ATOM: + if ctype == LMP_TYPE_VECTOR: + nlocal = self.lmp.extract_global("nlocal") + return self.darray(value, nlocal) + elif ctype == LMP_TYPE_ARRAY: + nlocal = self.lmp.extract_global("nlocal") + ncols = self.lmp.extract_compute(cid, cstyle, LMP_SIZE_COLS) + return self.darray(value, nlocal, ncols) + return value + + # ------------------------------------------------------------------------- + + def extract_fix(self, fid, fstyle, ftype, nrow=0, ncol=0): + """Retrieve data from a LAMMPS fix + + This is a wrapper around the :py:meth:`lammps.extract_fix() ` method. + It behaves the same as the original method, but returns NumPy arrays + instead of ``ctypes`` pointers. + + :param fid: fix ID + :type fid: string + :param fstyle: style of the data retrieve (global, atom, or local), see :ref:`py_style_constants` + :type fstyle: int + :param ftype: type or size of the returned data (scalar, vector, or array), see :ref:`py_type_constants` + :type ftype: int + :param nrow: index of global vector element or row index of global array element + :type nrow: int + :param ncol: column index of global array element + :type ncol: int + :return: requested data + :rtype: integer or double value, pointer to 1d or 2d double array or None + + """ + value = self.lmp.extract_fix(fid, fstyle, ftype, nrow, ncol) + if fstyle == LMP_STYLE_ATOM: + if ftype == LMP_TYPE_VECTOR: + nlocal = self.lmp.extract_global("nlocal") + return self.darray(value, nlocal) + elif ftype == LMP_TYPE_ARRAY: + nlocal = self.lmp.extract_global("nlocal") + ncols = self.lmp.extract_fix(fid, fstyle, LMP_SIZE_COLS, 0, 0) + return self.darray(value, nlocal, ncols) + elif fstyle == LMP_STYLE_LOCAL: + if ftype == LMP_TYPE_VECTOR: + nrows = self.lmp.extract_fix(fid, fstyle, LMP_SIZE_ROWS, 0, 0) + return self.darray(value, nrows) + elif ftype == LMP_TYPE_ARRAY: + nrows = self.lmp.extract_fix(fid, fstyle, LMP_SIZE_ROWS, 0, 0) + ncols = self.lmp.extract_fix(fid, fstyle, LMP_SIZE_COLS, 0, 0) + return self.darray(value, nrows, ncols) + return value + + # ------------------------------------------------------------------------- + + def extract_variable(self, name, group=None, vartype=LMP_VAR_EQUAL): + """ Evaluate a LAMMPS variable and return its data + + This function is a wrapper around the function + :py:meth:`lammps.extract_variable() ` + method. It behaves the same as the original method, but returns NumPy arrays + instead of ``ctypes`` pointers. + + :param name: name of the variable to execute + :type name: string + :param group: name of group for atom-style variable (ignored for equal-style variables) + :type group: string + :param vartype: type of variable, see :ref:`py_vartype_constants` + :type vartype: int + :return: the requested data or None + :rtype: c_double, numpy.array, or NoneType + """ + import numpy as np + value = self.lmp.extract_variable(name, group, vartype) + if vartype == LMP_VAR_ATOM: + return np.ctypeslib.as_array(value) + return value + + # ------------------------------------------------------------------------- + + def gather_bonds(self): + """Retrieve global list of bonds as NumPy array + + This is a wrapper around :py:meth:`lammps.gather_bonds() ` + It behaves the same as the original method, but returns a NumPy array instead + of a ``ctypes`` list. + + .. versionadded:: 28Jul2021 + + :return: the requested data as a 2d-integer numpy array + :rtype: numpy.array(nbonds,3) + """ + import numpy as np + nbonds, value = self.lmp.gather_bonds() + return np.ctypeslib.as_array(value).reshape(nbonds,3) + + # ------------------------------------------------------------------------- + + def fix_external_get_force(self, fix_id): + """Get access to the array with per-atom forces of a fix external instance with a given fix ID. + + This function is a wrapper around the + :py:meth:`lammps.fix_external_get_force() ` + method. It behaves the same as the original method, but returns a NumPy array instead + of a ``ctypes`` pointer. + + .. versionchanged:: 28Jul2021 + + :param fix_id: Fix-ID of a fix external instance + :type: string + :return: requested data + :rtype: numpy.array + """ + import numpy as np + nlocal = self.lmp.extract_setting('nlocal') + value = self.lmp.fix_external_get_force(fix_id) + return self.darray(value,nlocal,3) + + # ------------------------------------------------------------------------- + + def fix_external_set_energy_peratom(self, fix_id, eatom): + """Set the per-atom energy contribution for a fix external instance with the given ID. + + This function is an alternative to + :py:meth:`lammps.fix_external_set_energy_peratom() ` + method. It behaves the same as the original method, but accepts a NumPy array + instead of a list as argument. + + .. versionadded:: 28Jul2021 + + :param fix_id: Fix-ID of a fix external instance + :type: string + :param eatom: per-atom potential energy + :type: numpy.array + """ + import numpy as np + nlocal = self.lmp.extract_setting('nlocal') + if len(eatom) < nlocal: + raise Exception('per-atom energy dimension must be at least nlocal') + + c_double_p = POINTER(c_double) + value = eatom.astype(np.double) + return self.lmp.lib.lammps_fix_external_set_energy_peratom(self.lmp.lmp, fix_id.encode(), + value.ctypes.data_as(c_double_p)) + + # ------------------------------------------------------------------------- + + def fix_external_set_virial_peratom(self, fix_id, vatom): + """Set the per-atom virial contribution for a fix external instance with the given ID. + + This function is an alternative to + :py:meth:`lammps.fix_external_set_virial_peratom() ` + method. It behaves the same as the original method, but accepts a NumPy array + instead of a list as argument. + + .. versionadded:: 28Jul2021 + + :param fix_id: Fix-ID of a fix external instance + :type: string + :param eatom: per-atom potential energy + :type: numpy.array + """ + import numpy as np + nlocal = self.lmp.extract_setting('nlocal') + if len(vatom) < nlocal: + raise Exception('per-atom virial first dimension must be at least nlocal') + if len(vatom[0]) != 6: + raise Exception('per-atom virial second dimension must be 6') + + c_double_pp = np.ctypeslib.ndpointer(dtype=np.uintp, ndim=1, flags='C') + + # recast numpy array to be compatible with library interface + value = (vatom.__array_interface__['data'][0] + + np.arange(vatom.shape[0])*vatom.strides[0]).astype(np.uintp) + + # change prototype to our custom type + self.lmp.lib.lammps_fix_external_set_virial_peratom.argtypes = [ c_void_p, c_char_p, c_double_pp ] + + self.lmp.lib.lammps_fix_external_set_virial_peratom(self.lmp.lmp, fix_id.encode(), value) + + # ------------------------------------------------------------------------- + + def get_neighlist(self, idx): + """Returns an instance of :class:`NumPyNeighList` which wraps access to the neighbor list with the given index + + :param idx: index of neighbor list + :type idx: int + :return: an instance of :class:`NumPyNeighList` wrapping access to neighbor list data + :rtype: NumPyNeighList + """ + if idx < 0: + return None + return NumPyNeighList(self.lmp, idx) + + # ------------------------------------------------------------------------- + + def get_neighlist_element_neighbors(self, idx, element): + """Return data of neighbor list entry + + This function is a wrapper around the function + :py:meth:`lammps.get_neighlist_element_neighbors() ` + method. It behaves the same as the original method, but returns a NumPy array containing the neighbors + instead of a ``ctypes`` pointer. + + :param element: neighbor list index + :type element: int + :param element: neighbor list element index + :type element: int + :return: tuple with atom local index and numpy array of neighbor local atom indices + :rtype: (int, numpy.array) + """ + iatom, numneigh, c_neighbors = self.lmp.get_neighlist_element_neighbors(idx, element) + neighbors = self.iarray(c_int, c_neighbors, numneigh, 1) + return iatom, neighbors + + # ------------------------------------------------------------------------- + + def iarray(self, c_int_type, raw_ptr, nelem, dim=1): + if raw_ptr is None: + return None + + import numpy as np + np_int_type = self._ctype_to_numpy_int(c_int_type) + + if dim == 1: + ptr = cast(raw_ptr, POINTER(c_int_type * nelem)) + else: + ptr = cast(raw_ptr[0], POINTER(c_int_type * nelem * dim)) + + a = np.frombuffer(ptr.contents, dtype=np_int_type) + + if dim > 1: + a.shape = (nelem, dim) + else: + a.shape = (nelem) + return a + + # ------------------------------------------------------------------------- + + def darray(self, raw_ptr, nelem, dim=1): + if raw_ptr is None: + return None + + import numpy as np + + if dim == 1: + ptr = cast(raw_ptr, POINTER(c_double * nelem)) + else: + ptr = cast(raw_ptr[0], POINTER(c_double * nelem * dim)) + + a = np.frombuffer(ptr.contents) + + if dim > 1: + a.shape = (nelem, dim) + else: + a.shape = (nelem) + return a + +# ------------------------------------------------------------------------- + +class NumPyNeighList(NeighList): + """This is a wrapper class that exposes the contents of a neighbor list. + + It can be used like a regular Python list. Each element is a tuple of: + + * the atom local index + * a NumPy array containing the local atom indices of its neighbors + + Internally it uses the lower-level LAMMPS C-library interface. + + :param lmp: reference to instance of :py:class:`lammps` + :type lmp: lammps + :param idx: neighbor list index + :type idx: int + """ + def __init__(self, lmp, idx): + super(NumPyNeighList, self).__init__(lmp, idx) + + def get(self, element): + """ + Access a specific neighbor list entry. "element" must be a number from 0 to the size-1 of the list + + :return: tuple with atom local index, numpy array of neighbor local atom indices + :rtype: (int, numpy.array) + """ + iatom, neighbors = self.lmp.numpy.get_neighlist_element_neighbors(self.idx, element) + return iatom, neighbors + + def find(self, iatom): + """ + Find the neighbor list for a specific (local) atom iatom. + If there is no list for iatom, None is returned. + + :return: numpy array of neighbor local atom indices + :rtype: numpy.array or None + """ + inum = self.size + for ii in range(inum): + idx, neighbors = self.get(ii) + if idx == iatom: + return neighbors + return None diff --git a/python/lammps/pylammps.py b/python/lammps/pylammps.py new file mode 100644 index 0000000000..1fe1f2452b --- /dev/null +++ b/python/lammps/pylammps.py @@ -0,0 +1,990 @@ +# ---------------------------------------------------------------------- +# LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator +# https://www.lammps.org/ Sandia National Laboratories +# Steve Plimpton, sjplimp@sandia.gov +# +# Copyright (2003) Sandia Corporation. Under the terms of Contract +# DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains +# certain rights in this software. This software is distributed under +# the GNU General Public License. +# +# See the README file in the top-level LAMMPS directory. +# ------------------------------------------------------------------------- + +################################################################################ +# Alternative Python Wrapper +# Written by Richard Berger +################################################################################ + +# for python2/3 compatibility + +from __future__ import print_function + +import io +import os +import re +import sys +import tempfile +from collections import namedtuple + +from .core import lammps + +# ------------------------------------------------------------------------- + +class OutputCapture(object): + """ Utility class to capture LAMMPS library output """ + def __init__(self): + self.stdout_fd = 1 + self.captured_output = "" + + def __enter__(self): + self.tmpfile = tempfile.TemporaryFile(mode='w+b') + + sys.stdout.flush() + + # make copy of original stdout + self.stdout_orig = os.dup(self.stdout_fd) + + # replace stdout and redirect to temp file + os.dup2(self.tmpfile.fileno(), self.stdout_fd) + return self + + def __exit__(self, exc_type, exc_value, traceback): + os.dup2(self.stdout_orig, self.stdout_fd) + os.close(self.stdout_orig) + self.tmpfile.close() + + @property + def output(self): + sys.stdout.flush() + self.tmpfile.flush() + self.tmpfile.seek(0, io.SEEK_SET) + self.captured_output = self.tmpfile.read().decode('utf-8') + return self.captured_output + +# ------------------------------------------------------------------------- + +class Variable(object): + def __init__(self, pylammps_instance, name, style, definition): + self._pylmp = pylammps_instance + self.name = name + self.style = style + self.definition = definition.split() + + @property + def value(self): + if self.style == 'atom': + return list(self._pylmp.lmp.extract_variable(self.name, "all", 1)) + else: + value = self._pylmp.lmp_print('"${%s}"' % self.name).strip() + try: + return float(value) + except ValueError: + return value + +# ------------------------------------------------------------------------- + +class AtomList(object): + """ + A dynamic list of atoms that returns either an :py:class:`Atom` or + :py:class:`Atom2D` instance for each atom. Instances are only allocated + when accessed. + + :ivar natoms: total number of atoms + :ivar dimensions: number of dimensions in system + """ + def __init__(self, pylammps_instance): + self._pylmp = pylammps_instance + self.natoms = self._pylmp.system.natoms + self.dimensions = self._pylmp.system.dimensions + self._loaded = {} + + def __getitem__(self, index): + """ + Return Atom with given local index + + :param index: Local index of atom + :type index: int + :rtype: Atom or Atom2D + """ + if index not in self._loaded: + if self.dimensions == 2: + atom = Atom2D(self._pylmp, index) + else: + atom = Atom(self._pylmp, index) + self._loaded[index] = atom + return self._loaded[index] + + def __len__(self): + return self.natoms + + +# ------------------------------------------------------------------------- + +class Atom(object): + """ + A wrapper class then represents a single atom inside of LAMMPS + + It provides access to properties of the atom and allows you to change some of them. + """ + def __init__(self, pylammps_instance, index): + self._pylmp = pylammps_instance + self.index = index + + def __dir__(self): + return [k for k in super().__dir__() if not k.startswith('_')] + + def get(self, name, index): + prop = self._pylmp.lmp.numpy.extract_atom(name) + if prop is not None: + return prop[index] + return None + + @property + def id(self): + """ + Return the atom ID + + :type: int + """ + return self.get("id", self.index) + + @property + def type(self): + """ + Return the atom type + + :type: int + """ + return self.get("type", self.index) + + @property + def mol(self): + """ + Return the atom molecule index + + :type: int + """ + return self.get("mol", self.index) + + @property + def mass(self): + """ + Return the atom mass + + :type: float + """ + return self.get("mass", self.index) + + @property + def radius(self): + """ + Return the particle radius + + :type: float + """ + return self.get("radius", self.index) + + @property + def position(self): + """ + :getter: Return position of atom + :setter: Set position of atom + :type: numpy.array (float, float, float) + """ + return self.get("x", self.index) + + @position.setter + def position(self, value): + current = self.position + current[:] = value + + @property + def velocity(self): + """ + :getter: Return velocity of atom + :setter: Set velocity of atom + :type: numpy.array (float, float, float) + """ + return self.get("v", self.index) + + @velocity.setter + def velocity(self, value): + current = self.velocity + current[:] = value + + @property + def force(self): + """ + Return the total force acting on the atom + + :type: numpy.array (float, float, float) + """ + return self.get("f", self.index) + + @force.setter + def force(self, value): + current = self.force + current[:] = value + + @property + def torque(self): + """ + Return the total torque acting on the atom + + :type: numpy.array (float, float, float) + """ + return self.get("torque", self.index) + + @force.setter + def torque(self, value): + current = self.torque + current[:] = value + + @property + def omega(self): + """ + Return the rotational velocity of the particle + + :type: numpy.array (float, float, float) + """ + return self.get("torque", self.index) + + @omega.setter + def omega(self, value): + current = self.torque + current[:] = value + + @property + def torque(self): + """ + Return the total torque acting on the particle + + :type: numpy.array (float, float, float) + """ + return self.get("torque", self.index) + + @torque.setter + def torque(self, value): + current = self.torque + current[:] = value + + @property + def angular_momentum(self): + """ + Return the angular momentum of the particle + + :type: numpy.array (float, float, float) + """ + return self.get("angmom", self.index) + + @angular_momentum.setter + def angular_momentum(self, value): + current = self.angular_momentum + current[:] = value + + @property + def charge(self): + """ + Return the atom charge + + :type: float + """ + return self.get("q", self.index) + +# ------------------------------------------------------------------------- + +class Atom2D(Atom): + """ + A wrapper class then represents a single 2D atom inside of LAMMPS + + Inherits all properties from the :py:class:`Atom` class, but returns 2D versions + of position, velocity, and force. + + It provides access to properties of the atom and allows you to change some of them. + """ + def __init__(self, pylammps_instance, index): + super(Atom2D, self).__init__(pylammps_instance, index) + + @property + def position(self): + """Access to coordinates of an atom + + :getter: Return position of atom + :setter: Set position of atom + :type: numpy.array (float, float) + """ + return super(Atom2D, self).position[0:2] + + @position.setter + def position(self, value): + current = self.position + current[:] = value + + @property + def velocity(self): + """Access to velocity of an atom + :getter: Return velocity of atom + :setter: Set velocity of atom + :type: numpy.array (float, float) + """ + return super(Atom2D, self).velocity[0:2] + + @velocity.setter + def velocity(self, value): + current = self.velocity + current[:] = value + + @property + def force(self): + """Access to force of an atom + :getter: Return force of atom + :setter: Set force of atom + :type: numpy.array (float, float) + """ + return super(Atom2D, self).force[0:2] + + @force.setter + def force(self, value): + current = self.force + current[:] = value + +# ------------------------------------------------------------------------- + +class variable_set: + def __init__(self, name, variable_dict): + self._name = name + array_pattern = re.compile(r"(?P.+)\[(?P[0-9]+)\]") + + for key, value in variable_dict.items(): + m = array_pattern.match(key) + if m: + g = m.groupdict() + varname = g['arr'] + idx = int(g['index']) + if varname not in self.__dict__: + self.__dict__[varname] = {} + self.__dict__[varname][idx] = value + else: + self.__dict__[key] = value + + def __str__(self): + return "{}({})".format(self._name, ','.join(["{}={}".format(k, self.__dict__[k]) for k in self.__dict__.keys() if not k.startswith('_')])) + + def __dir__(self): + return [k for k in self.__dict__.keys() if not k.startswith('_')] + + def __repr__(self): + return self.__str__() + +# ------------------------------------------------------------------------- + +def get_thermo_data(output): + """ traverse output of runs and extract thermo data columns """ + if isinstance(output, str): + lines = output.splitlines() + else: + lines = output + + runs = [] + columns = [] + in_run = False + current_run = {} + + for line in lines: + if line.startswith("Per MPI rank memory allocation"): + in_run = True + elif in_run and len(columns) == 0: + # first line after memory usage are column names + columns = line.split() + + current_run = {} + + for col in columns: + current_run[col] = [] + + elif line.startswith("Loop time of "): + in_run = False + columns = [] + thermo_data = variable_set('ThermoData', current_run) + r = {'thermo' : thermo_data } + runs.append(namedtuple('Run', list(r.keys()))(*list(r.values()))) + elif in_run and len(columns) > 0: + items = line.split() + # Convert thermo output and store it. + # It must have the same number of columns and + # all of them must be convertible to floats. + # Otherwise we ignore the line + if len(items) == len(columns): + try: + values = [float(x) for x in items] + for i, col in enumerate(columns): + current_run[col].append(values[i]) + except ValueError: + # cannot convert. must be a non-thermo output. ignore. + pass + + return runs + +# ------------------------------------------------------------------------- +# ------------------------------------------------------------------------- + +class PyLammps(object): + """ + This is a Python wrapper class around the lower-level + :py:class:`lammps` class, exposing a more Python-like, + object-oriented interface for prototyping system inside of IPython and + Jupyter notebooks. + + It either creates its own instance of :py:class:`lammps` or can be + initialized with an existing instance. The arguments are the same of the + lower-level interface. The original interface can still be accessed via + :py:attr:`PyLammps.lmp`. + + :param name: "machine" name of the shared LAMMPS library ("mpi" loads ``liblammps_mpi.so``, "" loads ``liblammps.so``) + :type name: string + :param cmdargs: list of command line arguments to be passed to the :cpp:func:`lammps_open` function. The executable name is automatically added. + :type cmdargs: list + :param ptr: pointer to a LAMMPS C++ class instance when called from an embedded Python interpreter. None means load symbols from shared library. + :type ptr: pointer + :param comm: MPI communicator (as provided by `mpi4py `_). ``None`` means use ``MPI_COMM_WORLD`` implicitly. + :type comm: MPI_Comm + :param verbose: print all LAMMPS output to stdout + :type verbose: bool + + :ivar lmp: instance of original LAMMPS Python interface + :vartype lmp: :py:class:`lammps` + + :ivar runs: list of completed runs, each storing the thermo output + :vartype run: list + """ + + def __init__(self, name="", cmdargs=None, ptr=None, comm=None, verbose=False): + self.has_echo = False + self.verbose = verbose + + if cmdargs: + if '-echo' in cmdargs: + idx = cmdargs.index('-echo') + # ensures that echo line is ignored during output capture + self.has_echo = idx+1 < len(cmdargs) and cmdargs[idx+1] in ('screen', 'both') + + if ptr: + if isinstance(ptr,PyLammps): + self.lmp = ptr.lmp + elif isinstance(ptr,lammps): + self.lmp = ptr + else: + self.lmp = lammps(name=name,cmdargs=cmdargs,ptr=ptr,comm=comm) + else: + self.lmp = lammps(name=name,cmdargs=cmdargs,ptr=None,comm=comm) + print("LAMMPS output is captured by PyLammps wrapper") + self._cmd_history = [] + self._enable_cmd_history = False + self.runs = [] + + def __enter__(self): + return self + + def __exit__(self, ex_type, ex_value, ex_traceback): + self.close() + + def __del__(self): + if self.lmp: self.lmp.close() + self.lmp = None + + def close(self): + """Explicitly delete a LAMMPS instance + + This is a wrapper around the :py:meth:`lammps.close` of the Python interface. + """ + if self.lmp: self.lmp.close() + self.lmp = None + + def version(self): + """Return a numerical representation of the LAMMPS version in use. + + This is a wrapper around the :py:meth:`lammps.version` function of the Python interface. + + :return: version number + :rtype: int + """ + return self.lmp.version() + + def file(self, file): + """Read LAMMPS commands from a file. + + This is a wrapper around the :py:meth:`lammps.file` function of the Python interface. + + :param path: Name of the file/path with LAMMPS commands + :type path: string + """ + self.lmp.file(file) + + @property + def enable_cmd_history(self): + """ + :getter: Return whether command history is saved + :setter: Set if command history should be saved + :type: bool + """ + return self._enable_cmd_history + + @enable_cmd_history.setter + def enable_cmd_history(self, value): + """ + :getter: Return whether command history is saved + :setter: Set if command history should be saved + :type: bool + """ + self._enable_cmd_history = (value == True) + + def write_script(self, filepath): + """ + Write LAMMPS script file containing all commands executed up until now + + :param filepath: path to script file that should be written + :type filepath: string + """ + with open(filepath, "w") as f: + for cmd in self._cmd_history: + print(cmd, file=f) + + def clear_cmd_history(self): + """ + Clear LAMMPS command history up to this point + """ + self._cmd_history = [] + + def command(self, cmd): + """ + Execute LAMMPS command + + If :py:attr:`PyLammps.enable_cmd_history` is set to ``True``, commands executed + will be recorded. The entire command history can be written to a file using + :py:meth:`PyLammps.write_script()`. To clear the command history, use + :py:meth:`PyLammps.clear_cmd_history()`. + + :param cmd: command string that should be executed + :type: cmd: string + """ + self.lmp.command(cmd) + + if self.enable_cmd_history: + self._cmd_history.append(cmd) + + def run(self, *args, **kwargs): + """ + Execute LAMMPS run command with given arguments + + All thermo output during the run is captured and saved as new entry in + :py:attr:`PyLammps.runs`. The latest run can be retrieved by + :py:attr:`PyLammps.last_run`. + """ + output = self.__getattr__('run')(*args, **kwargs) + self.runs += get_thermo_data(output) + return output + + @property + def last_run(self): + """ + Return data produced of last completed run command + + :getter: Returns an object containing information about the last run command + :type: dict + """ + if len(self.runs) > 0: + return self.runs[-1] + return None + + @property + def atoms(self): + """ + All atoms of this LAMMPS instance + + :getter: Returns a list of atoms currently in the system + :type: AtomList + """ + return AtomList(self) + + @property + def system(self): + """ + The system state of this LAMMPS instance + + :getter: Returns an object with properties storing the current system state + :type: namedtuple + """ + output = self.lmp_info("system") + output = output[output.index("System information:")+1:] + d = self._parse_info_system(output) + return namedtuple('System', d.keys())(*d.values()) + + @property + def communication(self): + """ + The communication state of this LAMMPS instance + + :getter: Returns an object with properties storing the current communication state + :type: namedtuple + """ + output = self.lmp_info("communication") + output = output[output.index("Communication information:")+1:] + d = self._parse_info_communication(output) + return namedtuple('Communication', d.keys())(*d.values()) + + @property + def computes(self): + """ + The list of active computes of this LAMMPS instance + + :getter: Returns a list of computes that are currently active in this LAMMPS instance + :type: list + """ + output = self.lmp_info("computes") + output = output[output.index("Compute information:")+1:] + return self._parse_element_list(output) + + @property + def dumps(self): + """ + The list of active dumps of this LAMMPS instance + + :getter: Returns a list of dumps that are currently active in this LAMMPS instance + :type: list + """ + output = self.lmp_info("dumps") + output = output[output.index("Dump information:")+1:] + return self._parse_element_list(output) + + @property + def fixes(self): + """ + The list of active fixes of this LAMMPS instance + + :getter: Returns a list of fixes that are currently active in this LAMMPS instance + :type: list + """ + output = self.lmp_info("fixes") + output = output[output.index("Fix information:")+1:] + return self._parse_element_list(output) + + @property + def groups(self): + """ + The list of active atom groups of this LAMMPS instance + + :getter: Returns a list of atom groups that are currently active in this LAMMPS instance + :type: list + """ + output = self.lmp_info("groups") + output = output[output.index("Group information:")+1:] + return self._parse_groups(output) + + @property + def variables(self): + """ + Returns a dictionary of all variables defined in the current LAMMPS instance + + :getter: Returns a dictionary of all variables that are defined in this LAMMPS instance + :type: dict + """ + output = self.lmp_info("variables") + output = output[output.index("Variable information:")+1:] + variables = {} + for v in self._parse_element_list(output): + variables[v['name']] = Variable(self, v['name'], v['style'], v['def']) + return variables + + def eval(self, expr): + """ + Evaluate expression + + :param expr: the expression string that should be evaluated inside of LAMMPS + :type expr: string + + :return: the value of the evaluated expression + :rtype: float if numeric, string otherwise + """ + value = self.lmp_print('"$(%s)"' % expr).strip() + try: + return float(value) + except ValueError: + return value + + def _split_values(self, line): + return [x.strip() for x in line.split(',')] + + def _get_pair(self, value): + return [x.strip() for x in value.split('=')] + + def _parse_info_system(self, output): + system = {} + + for line in output: + if line.startswith("Units"): + system['units'] = self._get_pair(line)[1] + elif line.startswith("Atom style"): + system['atom_style'] = self._get_pair(line)[1] + elif line.startswith("Atom map"): + system['atom_map'] = self._get_pair(line)[1] + elif line.startswith("Atoms"): + parts = self._split_values(line) + system['natoms'] = int(self._get_pair(parts[0])[1]) + system['ntypes'] = int(self._get_pair(parts[1])[1]) + system['style'] = self._get_pair(parts[2])[1] + elif line.startswith("Kspace style"): + system['kspace_style'] = self._get_pair(line)[1] + elif line.startswith("Dimensions"): + system['dimensions'] = int(self._get_pair(line)[1]) + elif line.startswith("Orthogonal box"): + system['orthogonal_box'] = [float(x) for x in self._get_pair(line)[1].split('x')] + elif line.startswith("Boundaries"): + system['boundaries'] = self._get_pair(line)[1] + elif line.startswith("xlo"): + keys, values = [self._split_values(x) for x in self._get_pair(line)] + for key, value in zip(keys, values): + system[key] = float(value) + elif line.startswith("ylo"): + keys, values = [self._split_values(x) for x in self._get_pair(line)] + for key, value in zip(keys, values): + system[key] = float(value) + elif line.startswith("zlo"): + keys, values = [self._split_values(x) for x in self._get_pair(line)] + for key, value in zip(keys, values): + system[key] = float(value) + elif line.startswith("Molecule type"): + system['molecule_type'] = self._get_pair(line)[1] + elif line.startswith("Bonds"): + parts = self._split_values(line) + system['nbonds'] = int(self._get_pair(parts[0])[1]) + system['nbondtypes'] = int(self._get_pair(parts[1])[1]) + system['bond_style'] = self._get_pair(parts[2])[1] + elif line.startswith("Angles"): + parts = self._split_values(line) + system['nangles'] = int(self._get_pair(parts[0])[1]) + system['nangletypes'] = int(self._get_pair(parts[1])[1]) + system['angle_style'] = self._get_pair(parts[2])[1] + elif line.startswith("Dihedrals"): + parts = self._split_values(line) + system['ndihedrals'] = int(self._get_pair(parts[0])[1]) + system['ndihedraltypes'] = int(self._get_pair(parts[1])[1]) + system['dihedral_style'] = self._get_pair(parts[2])[1] + elif line.startswith("Impropers"): + parts = self._split_values(line) + system['nimpropers'] = int(self._get_pair(parts[0])[1]) + system['nimpropertypes'] = int(self._get_pair(parts[1])[1]) + system['improper_style'] = self._get_pair(parts[2])[1] + + return system + + def _parse_info_communication(self, output): + comm = {} + + for line in output: + if line.startswith("MPI library"): + comm['mpi_version'] = line.split(':')[1].strip() + elif line.startswith("Comm style"): + parts = self._split_values(line) + comm['comm_style'] = self._get_pair(parts[0])[1] + comm['comm_layout'] = self._get_pair(parts[1])[1] + elif line.startswith("Processor grid"): + comm['proc_grid'] = [int(x) for x in self._get_pair(line)[1].split('x')] + elif line.startswith("Communicate velocities for ghost atoms"): + comm['ghost_velocity'] = (self._get_pair(line)[1] == "yes") + elif line.startswith("Nprocs"): + parts = self._split_values(line) + comm['nprocs'] = int(self._get_pair(parts[0])[1]) + comm['nthreads'] = int(self._get_pair(parts[1])[1]) + return comm + + def _parse_element_list(self, output): + elements = [] + + for line in output: + if not line or (":" not in line): continue + element_info = self._split_values(line.split(':')[1].strip()) + element = {'name': element_info[0]} + for key, value in [self._get_pair(x) for x in element_info[1:]]: + element[key] = value + elements.append(element) + return elements + + def _parse_groups(self, output): + groups = [] + group_pattern = re.compile(r"(?P.+) \((?P.+)\)") + + for line in output: + m = group_pattern.match(line.split(':')[1].strip()) + group = {'name': m.group('name'), 'type': m.group('type')} + groups.append(group) + return groups + + def lmp_print(self, s): + """ needed for Python2 compatibility, since print is a reserved keyword """ + return self.__getattr__("print")(s) + + def __dir__(self): + return sorted(set(['angle_coeff', 'angle_style', 'atom_modify', 'atom_style', 'atom_style', + 'bond_coeff', 'bond_style', 'boundary', 'change_box', 'communicate', 'compute', + 'create_atoms', 'create_box', 'delete_atoms', 'delete_bonds', 'dielectric', + 'dihedral_coeff', 'dihedral_style', 'dimension', 'dump', 'fix', 'fix_modify', + 'group', 'improper_coeff', 'improper_style', 'include', 'kspace_modify', + 'kspace_style', 'lattice', 'mass', 'minimize', 'min_style', 'neighbor', + 'neigh_modify', 'newton', 'nthreads', 'pair_coeff', 'pair_modify', + 'pair_style', 'processors', 'read', 'read_data', 'read_restart', 'region', + 'replicate', 'reset_timestep', 'restart', 'run', 'run_style', 'thermo', + 'thermo_modify', 'thermo_style', 'timestep', 'undump', 'unfix', 'units', + 'variable', 'velocity', 'write_restart'] + self.lmp.available_styles("command"))) + + def lmp_info(self, s): + # skip anything before and after Info-Info-Info + # also skip timestamp line + output = self.__getattr__("info")(s) + indices = [index for index, line in enumerate(output) if line.startswith("Info-Info-Info-Info")] + start = indices[0] + end = indices[1] + return [line for line in output[start+2:end] if line] + + def __getattr__(self, name): + """ + This method is where the Python 'magic' happens. If a method is not + defined by the class PyLammps, it assumes it is a LAMMPS command. It takes + all the arguments, concatinates them to a single string, and executes it using + :py:meth:`lammps.PyLammps.command()`. + + :param verbose: Print output of command + :type verbose: bool + :return: line or list of lines of output, None if no output + :rtype: list or string + """ + def handler(*args, **kwargs): + cmd_args = [name] + [str(x) for x in args] + self.lmp.flush_buffers() + + with OutputCapture() as capture: + cmd = ' '.join(cmd_args) + self.command(cmd) + self.lmp.flush_buffers() + output = capture.output + + comm = self.lmp.get_mpi_comm() + if comm: + output = self.lmp.comm.bcast(output, root=0) + + if self.verbose or ('verbose' in kwargs and kwargs['verbose']): + print(output, end = '') + + lines = output.splitlines() + + if self.has_echo: + lines = lines[1:] + + if len(lines) > 1: + return lines + elif len(lines) == 1: + return lines[0] + return None + + return handler + + +class IPyLammps(PyLammps): + """ + IPython wrapper for LAMMPS which adds embedded graphics capabilities to PyLammmps interface + + It either creates its own instance of :py:class:`lammps` or can be + initialized with an existing instance. The arguments are the same of the + lower-level interface. The original interface can still be accessed via + :py:attr:`PyLammps.lmp`. + + :param name: "machine" name of the shared LAMMPS library ("mpi" loads ``liblammps_mpi.so``, "" loads ``liblammps.so``) + :type name: string + :param cmdargs: list of command line arguments to be passed to the :cpp:func:`lammps_open` function. The executable name is automatically added. + :type cmdargs: list + :param ptr: pointer to a LAMMPS C++ class instance when called from an embedded Python interpreter. None means load symbols from shared library. + :type ptr: pointer + :param comm: MPI communicator (as provided by `mpi4py `_). ``None`` means use ``MPI_COMM_WORLD`` implicitly. + :type comm: MPI_Comm + """ + + def __init__(self,name="",cmdargs=None,ptr=None,comm=None): + super(IPyLammps, self).__init__(name=name,cmdargs=cmdargs,ptr=ptr,comm=comm) + + def image(self, filename="snapshot.png", group="all", color="type", diameter="type", + size=None, view=None, center=None, up=None, zoom=1.0, background_color="white"): + """ Generate image using write_dump command and display it + + See :doc:`dump image ` for more information. + + :param filename: Name of the image file that should be generated. The extension determines whether it is PNG or JPEG + :type filename: string + :param group: the group of atoms write_image should use + :type group: string + :param color: name of property used to determine color + :type color: string + :param diameter: name of property used to determine atom diameter + :type diameter: string + :param size: dimensions of image + :type size: tuple (width, height) + :param view: view parameters + :type view: tuple (theta, phi) + :param center: center parameters + :type center: tuple (flag, center_x, center_y, center_z) + :param up: vector pointing to up direction + :type up: tuple (up_x, up_y, up_z) + :param zoom: zoom factor + :type zoom: float + :param background_color: background color of scene + :type background_color: string + + :return: Image instance used to display image in notebook + :rtype: :py:class:`IPython.core.display.Image` + """ + cmd_args = [group, "image", filename, color, diameter] + + if size is not None: + width = size[0] + height = size[1] + cmd_args += ["size", width, height] + + if view is not None: + theta = view[0] + phi = view[1] + cmd_args += ["view", theta, phi] + + if center is not None: + flag = center[0] + Cx = center[1] + Cy = center[2] + Cz = center[3] + cmd_args += ["center", flag, Cx, Cy, Cz] + + if up is not None: + Ux = up[0] + Uy = up[1] + Uz = up[2] + cmd_args += ["up", Ux, Uy, Uz] + + if zoom is not None: + cmd_args += ["zoom", zoom] + + cmd_args.append("modify backcolor " + background_color) + + self.write_dump(*cmd_args) + from IPython.core.display import Image + return Image(filename) + + def video(self, filename): + """ + Load video from file + + Can be used to visualize videos from :doc:`dump movie `. + + :param filename: Path to video file + :type filename: string + :return: HTML Video Tag used by notebook to embed a video + :rtype: :py:class:`IPython.display.HTML` + """ + from IPython.display import HTML + return HTML("") From 139ecad13cfab035760217d95d2ff1b73f1a596c Mon Sep 17 00:00:00 2001 From: rohskopf Date: Thu, 7 Jul 2022 17:12:40 -0600 Subject: [PATCH 554/585] Trying to remove symlink --- python/lammps/__init__.py | 49 - python/lammps/constants.py | 48 - python/lammps/core.py | 2097 ------------------------------- python/lammps/data.py | 92 -- python/lammps/formats.py | 227 ---- python/lammps/mliap/__init__.py | 20 - python/lammps/mliap/loader.py | 52 - python/lammps/mliap/pytorch.py | 326 ----- python/lammps/numpy_wrapper.py | 483 ------- python/lammps/pylammps.py | 990 --------------- 10 files changed, 4384 deletions(-) delete mode 100644 python/lammps/__init__.py delete mode 100644 python/lammps/constants.py delete mode 100644 python/lammps/core.py delete mode 100644 python/lammps/data.py delete mode 100644 python/lammps/formats.py delete mode 100644 python/lammps/mliap/__init__.py delete mode 100644 python/lammps/mliap/loader.py delete mode 100644 python/lammps/mliap/pytorch.py delete mode 100644 python/lammps/numpy_wrapper.py delete mode 100644 python/lammps/pylammps.py diff --git a/python/lammps/__init__.py b/python/lammps/__init__.py deleted file mode 100644 index fc35e45225..0000000000 --- a/python/lammps/__init__.py +++ /dev/null @@ -1,49 +0,0 @@ -""" -LAMMPS module global members: - -.. data:: __version__ - - Numerical representation of the LAMMPS version this - module was taken from. Has the same format as the - result of :py:func:`lammps.version`. -""" - -from .constants import * # lgtm [py/polluting-import] -from .core import * # lgtm [py/polluting-import] -from .data import * # lgtm [py/polluting-import] -from .pylammps import * # lgtm [py/polluting-import] - -# convert installed module string version to numeric version -def get_version_number(): - import time - from os.path import join - from sys import version_info - - # must report 0 when inside LAMMPS source tree - if __file__.find(join('python', 'lammps', '__init__.py')) > 0: - return 0 - - vstring = None - if version_info.major == 3 and version_info.minor >= 8: - from importlib.metadata import version, PackageNotFoundError - try: - vstring = version('lammps') - except PackageNotFoundError: - # nothing to do, ignore - pass - - else: - from pkg_resources import get_distribution, DistributionNotFound - try: - vstring = get_distribution('lammps').version - except DistributionNotFound: - # nothing to do, ignore - pass - - if not vstring: - return 0 - - t = time.strptime(vstring, "%Y.%m.%d") - return t.tm_year*10000 + t.tm_mon*100 + t.tm_mday - -__version__ = get_version_number() diff --git a/python/lammps/constants.py b/python/lammps/constants.py deleted file mode 100644 index a50d58b28f..0000000000 --- a/python/lammps/constants.py +++ /dev/null @@ -1,48 +0,0 @@ -# ---------------------------------------------------------------------- -# LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator -# https://www.lammps.org/ Sandia National Laboratories -# Steve Plimpton, sjplimp@sandia.gov -# -# Copyright (2003) Sandia Corporation. Under the terms of Contract -# DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains -# certain rights in this software. This software is distributed under -# the GNU General Public License. -# -# See the README file in the top-level LAMMPS directory. -# ------------------------------------------------------------------------- - -# various symbolic constants to be used -# in certain calls to select data formats -LAMMPS_AUTODETECT = None -LAMMPS_INT = 0 -LAMMPS_INT_2D = 1 -LAMMPS_DOUBLE = 2 -LAMMPS_DOUBLE_2D = 3 -LAMMPS_INT64 = 4 -LAMMPS_INT64_2D = 5 -LAMMPS_STRING = 6 - -# these must be kept in sync with the enums in library.h -LMP_STYLE_GLOBAL = 0 -LMP_STYLE_ATOM = 1 -LMP_STYLE_LOCAL = 2 - -LMP_TYPE_SCALAR = 0 -LMP_TYPE_VECTOR = 1 -LMP_TYPE_ARRAY = 2 -LMP_SIZE_VECTOR = 3 -LMP_SIZE_ROWS = 4 -LMP_SIZE_COLS = 5 - -LMP_VAR_EQUAL = 0 -LMP_VAR_ATOM = 1 - -# ------------------------------------------------------------------------- - -def get_ctypes_int(size): - from ctypes import c_int, c_int32, c_int64 - if size == 4: - return c_int32 - elif size == 8: - return c_int64 - return c_int diff --git a/python/lammps/core.py b/python/lammps/core.py deleted file mode 100644 index 930a40a4b0..0000000000 --- a/python/lammps/core.py +++ /dev/null @@ -1,2097 +0,0 @@ -# ---------------------------------------------------------------------- -# LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator -# https://www.lammps.org/ Sandia National Laboratories -# Steve Plimpton, sjplimp@sandia.gov -# -# Copyright (2003) Sandia Corporation. Under the terms of Contract -# DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains -# certain rights in this software. This software is distributed under -# the GNU General Public License. -# -# See the README file in the top-level LAMMPS directory. -# ------------------------------------------------------------------------- -# Python wrapper for the LAMMPS library via ctypes - -# for python2/3 compatibility - -from __future__ import print_function - -import os -import sys -from ctypes import * # lgtm [py/polluting-import] -from os.path import dirname,abspath,join -from inspect import getsourcefile - -from .constants import * # lgtm [py/polluting-import] -from .data import * # lgtm [py/polluting-import] - -# ------------------------------------------------------------------------- - -class MPIAbortException(Exception): - def __init__(self, message): - self.message = message - - def __str__(self): - return repr(self.message) - -# ------------------------------------------------------------------------- - -class ExceptionCheck: - """Utility class to rethrow LAMMPS C++ exceptions as Python exceptions""" - def __init__(self, lmp): - self.lmp = lmp - - def __enter__(self): - pass - - def __exit__(self, exc_type, exc_value, traceback): - if self.lmp.has_exceptions and self.lmp.lib.lammps_has_error(self.lmp.lmp): - raise self.lmp._lammps_exception - -# ------------------------------------------------------------------------- - -class lammps(object): - """Create an instance of the LAMMPS Python class. - - .. _mpi4py_docs: https://mpi4py.readthedocs.io/ - - This is a Python wrapper class that exposes the LAMMPS C-library - interface to Python. It either requires that LAMMPS has been compiled - as shared library which is then dynamically loaded via the ctypes - Python module or that this module called from a Python function that - is called from a Python interpreter embedded into a LAMMPS executable, - for example through the :doc:`python invoke ` command. - When the class is instantiated it calls the :cpp:func:`lammps_open` - function of the LAMMPS C-library interface, which in - turn will create an instance of the :cpp:class:`LAMMPS ` - C++ class. The handle to this C++ class is stored internally - and automatically passed to the calls to the C library interface. - - :param name: "machine" name of the shared LAMMPS library ("mpi" loads ``liblammps_mpi.so``, "" loads ``liblammps.so``) - :type name: string - :param cmdargs: list of command line arguments to be passed to the :cpp:func:`lammps_open` function. The executable name is automatically added. - :type cmdargs: list - :param ptr: pointer to a LAMMPS C++ class instance when called from an embedded Python interpreter. None means load symbols from shared library. - :type ptr: pointer - :param comm: MPI communicator (as provided by `mpi4py `_). ``None`` means use ``MPI_COMM_WORLD`` implicitly. - :type comm: MPI_Comm - """ - - # ------------------------------------------------------------------------- - # create an instance of LAMMPS - - def __init__(self,name='',cmdargs=None,ptr=None,comm=None): - self.comm = comm - self.opened = 0 - - # determine module file location - - modpath = dirname(abspath(getsourcefile(lambda:0))) - # for windows installers the shared library is in a different folder - winpath = abspath(os.path.join(modpath,'..','..','bin')) - # allow override for running tests on Windows - if (os.environ.get("LAMMPSDLLPATH")): - winpath = os.environ.get("LAMMPSDLLPATH") - self.lib = None - self.lmp = None - - # if a pointer to a LAMMPS object is handed in - # when being called from a Python interpreter - # embedded into a LAMMPS executable, all library - # symbols should already be available so we do not - # load a shared object. - - try: - if ptr is not None: self.lib = CDLL("",RTLD_GLOBAL) - except OSError: - self.lib = None - - # load liblammps.so unless name is given - # if name = "g++", load liblammps_g++.so - # try loading the LAMMPS shared object from the location - # of the lammps package with an absolute path, - # so that LD_LIBRARY_PATH does not need to be set for regular install - # fall back to loading with a relative path, - # typically requires LD_LIBRARY_PATH to be set appropriately - # guess shared library extension based on OS, if not inferred from actual file - - if any([f.startswith('liblammps') and f.endswith('.dylib') - for f in os.listdir(modpath)]): - lib_ext = ".dylib" - elif any([f.startswith('liblammps') and f.endswith('.dll') - for f in os.listdir(modpath)]): - lib_ext = ".dll" - elif os.path.exists(winpath) and any([f.startswith('liblammps') and f.endswith('.dll') - for f in os.listdir(winpath)]): - lib_ext = ".dll" - modpath = winpath - elif any([f.startswith('liblammps') and f.endswith('.so') - for f in os.listdir(modpath)]): - lib_ext = ".so" - else: - import platform - if platform.system() == "Darwin": - lib_ext = ".dylib" - elif platform.system() == "Windows": - lib_ext = ".dll" - else: - lib_ext = ".so" - - if not self.lib: - if name: - libpath = join(modpath,"liblammps_%s" % name + lib_ext) - else: - libpath = join(modpath,"liblammps" + lib_ext) - if not os.path.isfile(libpath): - if name: - libpath = "liblammps_%s" % name + lib_ext - else: - libpath = "liblammps" + lib_ext - self.lib = CDLL(libpath,RTLD_GLOBAL) - - # declare all argument and return types for all library methods here. - # exceptions are where the arguments depend on certain conditions and - # then are defined where the functions are used. - self.lib.lammps_extract_setting.argtypes = [c_void_p, c_char_p] - self.lib.lammps_extract_setting.restype = c_int - - # set default types - # needed in later declarations - self.c_bigint = get_ctypes_int(self.extract_setting("bigint")) - self.c_tagint = get_ctypes_int(self.extract_setting("tagint")) - self.c_imageint = get_ctypes_int(self.extract_setting("imageint")) - - self.lib.lammps_open.restype = c_void_p - self.lib.lammps_open_no_mpi.restype = c_void_p - self.lib.lammps_close.argtypes = [c_void_p] - self.lib.lammps_flush_buffers.argtypes = [c_void_p] - self.lib.lammps_free.argtypes = [c_void_p] - - self.lib.lammps_file.argtypes = [c_void_p, c_char_p] - self.lib.lammps_file.restype = None - - self.lib.lammps_command.argtypes = [c_void_p, c_char_p] - self.lib.lammps_command.restype = c_char_p - self.lib.lammps_commands_list.restype = None - self.lib.lammps_commands_string.argtypes = [c_void_p, c_char_p] - self.lib.lammps_commands_string.restype = None - - self.lib.lammps_get_natoms.argtypes = [c_void_p] - self.lib.lammps_get_natoms.restype = c_double - self.lib.lammps_extract_box.argtypes = \ - [c_void_p,POINTER(c_double),POINTER(c_double), - POINTER(c_double),POINTER(c_double),POINTER(c_double), - POINTER(c_int),POINTER(c_int)] - self.lib.lammps_extract_box.restype = None - - self.lib.lammps_reset_box.argtypes = \ - [c_void_p,POINTER(c_double),POINTER(c_double),c_double,c_double,c_double] - self.lib.lammps_reset_box.restype = None - - self.lib.lammps_gather_atoms.argtypes = [c_void_p,c_char_p,c_int,c_int,c_void_p] - self.lib.lammps_gather_atoms.restype = None - - self.lib.lammps_gather_atoms_concat.argtypes = [c_void_p,c_char_p,c_int,c_int,c_void_p] - self.lib.lammps_gather_atoms_concat.restype = None - - self.lib.lammps_gather_atoms_subset.argtypes = \ - [c_void_p,c_char_p,c_int,c_int,c_int,POINTER(c_int),c_void_p] - self.lib.lammps_gather_atoms_subset.restype = None - - self.lib.lammps_scatter_atoms.argtypes = [c_void_p,c_char_p,c_int,c_int,c_void_p] - self.lib.lammps_scatter_atoms.restype = None - - self.lib.lammps_scatter_atoms_subset.argtypes = \ - [c_void_p,c_char_p,c_int,c_int,c_int,POINTER(c_int),c_void_p] - self.lib.lammps_scatter_atoms_subset.restype = None - - self.lib.lammps_gather_bonds.argtypes = [c_void_p,c_void_p] - self.lib.lammps_gather_bonds.restype = None - - self.lib.lammps_gather.argtypes = [c_void_p,c_char_p,c_int,c_int,c_void_p] - self.lib.lammps_gather.restype = None - - self.lib.lammps_gather_concat.argtypes = [c_void_p,c_char_p,c_int,c_int,c_void_p] - self.lib.lammps_gather_concat.restype = None - - self.lib.lammps_gather_subset.argtypes = \ - [c_void_p,c_char_p,c_int,c_int,c_int,POINTER(c_int),c_void_p] - self.lib.lammps_gather_subset.restype = None - - self.lib.lammps_scatter.argtypes = [c_void_p,c_char_p,c_int,c_int,c_void_p] - self.lib.lammps_scatter.restype = None - - self.lib.lammps_scatter_subset.argtypes = \ - [c_void_p,c_char_p,c_int,c_int,c_int,POINTER(c_int),c_void_p] - self.lib.lammps_scatter_subset.restype = None - - - self.lib.lammps_find_pair_neighlist.argtypes = [c_void_p, c_char_p, c_int, c_int, c_int] - self.lib.lammps_find_pair_neighlist.restype = c_int - - self.lib.lammps_find_fix_neighlist.argtypes = [c_void_p, c_char_p, c_int] - self.lib.lammps_find_fix_neighlist.restype = c_int - - self.lib.lammps_find_compute_neighlist.argtypes = [c_void_p, c_char_p, c_int] - self.lib.lammps_find_compute_neighlist.restype = c_int - - self.lib.lammps_neighlist_num_elements.argtypes = [c_void_p, c_int] - self.lib.lammps_neighlist_num_elements.restype = c_int - - self.lib.lammps_neighlist_element_neighbors.argtypes = \ - [c_void_p, c_int, c_int, POINTER(c_int), POINTER(c_int), POINTER(POINTER(c_int))] - self.lib.lammps_neighlist_element_neighbors.restype = None - - self.lib.lammps_is_running.argtypes = [c_void_p] - self.lib.lammps_is_running.restype = c_int - - self.lib.lammps_force_timeout.argtypes = [c_void_p] - - self.lib.lammps_has_error.argtypes = [c_void_p] - self.lib.lammps_has_error.restype = c_int - - self.lib.lammps_get_last_error_message.argtypes = [c_void_p, c_char_p, c_int] - self.lib.lammps_get_last_error_message.restype = c_int - - self.lib.lammps_extract_global.argtypes = [c_void_p, c_char_p] - self.lib.lammps_extract_global_datatype.argtypes = [c_void_p, c_char_p] - self.lib.lammps_extract_global_datatype.restype = c_int - self.lib.lammps_extract_compute.argtypes = [c_void_p, c_char_p, c_int, c_int] - - self.lib.lammps_get_thermo.argtypes = [c_void_p, c_char_p] - self.lib.lammps_get_thermo.restype = c_double - - self.lib.lammps_encode_image_flags.restype = self.c_imageint - - self.lib.lammps_config_package_name.argtypes = [c_int, c_char_p, c_int] - self.lib.lammps_config_accelerator.argtypes = [c_char_p, c_char_p, c_char_p] - - self.lib.lammps_set_variable.argtypes = [c_void_p, c_char_p, c_char_p] - - self.lib.lammps_has_style.argtypes = [c_void_p, c_char_p, c_char_p] - - self.lib.lammps_style_count.argtypes = [c_void_p, c_char_p] - - self.lib.lammps_style_name.argtypes = [c_void_p, c_char_p, c_int, c_char_p, c_int] - - self.lib.lammps_has_id.argtypes = [c_void_p, c_char_p, c_char_p] - - self.lib.lammps_id_count.argtypes = [c_void_p, c_char_p] - - self.lib.lammps_id_name.argtypes = [c_void_p, c_char_p, c_int, c_char_p, c_int] - - self.lib.lammps_plugin_count.argtypes = [ ] - self.lib.lammps_plugin_name.argtypes = [c_int, c_char_p, c_char_p, c_int] - - self.lib.lammps_version.argtypes = [c_void_p] - - self.lib.lammps_get_os_info.argtypes = [c_char_p, c_int] - self.lib.lammps_get_gpu_device_info.argtypes = [c_char_p, c_int] - - self.lib.lammps_get_mpi_comm.argtypes = [c_void_p] - - self.lib.lammps_decode_image_flags.argtypes = [self.c_imageint, POINTER(c_int*3)] - - self.lib.lammps_extract_atom.argtypes = [c_void_p, c_char_p] - self.lib.lammps_extract_atom_datatype.argtypes = [c_void_p, c_char_p] - self.lib.lammps_extract_atom_datatype.restype = c_int - - self.lib.lammps_extract_fix.argtypes = [c_void_p, c_char_p, c_int, c_int, c_int, c_int] - - self.lib.lammps_extract_variable.argtypes = [c_void_p, c_char_p, c_char_p] - - self.lib.lammps_fix_external_get_force.argtypes = [c_void_p, c_char_p] - self.lib.lammps_fix_external_get_force.restype = POINTER(POINTER(c_double)) - - self.lib.lammps_fix_external_set_energy_global.argtypes = [c_void_p, c_char_p, c_double] - self.lib.lammps_fix_external_set_virial_global.argtypes = [c_void_p, c_char_p, POINTER(c_double)] - self.lib.lammps_fix_external_set_energy_peratom.argtypes = [c_void_p, c_char_p, POINTER(c_double)] - self.lib.lammps_fix_external_set_virial_peratom.argtypes = [c_void_p, c_char_p, POINTER(POINTER(c_double))] - - self.lib.lammps_fix_external_set_vector_length.argtypes = [c_void_p, c_char_p, c_int] - self.lib.lammps_fix_external_set_vector.argtypes = [c_void_p, c_char_p, c_int, c_double] - - # detect if Python is using a version of mpi4py that can pass communicators - # only needed if LAMMPS has been compiled with MPI support. - self.has_mpi4py = False - if self.has_mpi_support: - try: - from mpi4py import __version__ as mpi4py_version - # tested to work with mpi4py versions 2 and 3 - self.has_mpi4py = mpi4py_version.split('.')[0] in ['2','3'] - except ImportError: - # ignore failing import - pass - - # if no ptr provided, create an instance of LAMMPS - # we can pass an MPI communicator from mpi4py v2.0.0 and later - # no_mpi call lets LAMMPS use MPI_COMM_WORLD - # cargs = array of C strings from args - # if ptr, then are embedding Python in LAMMPS input script - # ptr is the desired instance of LAMMPS - # just convert it to ctypes ptr and store in self.lmp - - if ptr is None: - - # with mpi4py v2+, we can pass MPI communicators to LAMMPS - # need to adjust for type of MPI communicator object - # allow for int (like MPICH) or void* (like OpenMPI) - if self.has_mpi_support and self.has_mpi4py: - from mpi4py import MPI - self.MPI = MPI - - if comm is not None: - if not self.has_mpi_support: - raise Exception('LAMMPS not compiled with real MPI library') - if not self.has_mpi4py: - raise Exception('Python mpi4py version is not 2 or 3') - if self.MPI._sizeof(self.MPI.Comm) == sizeof(c_int): - MPI_Comm = c_int - else: - MPI_Comm = c_void_p - - # Detect whether LAMMPS and mpi4py definitely use different MPI libs - if sizeof(MPI_Comm) != self.lib.lammps_config_has_mpi_support(): - raise Exception('Inconsistent MPI library in LAMMPS and mpi4py') - - narg = 0 - cargs = None - if cmdargs is not None: - cmdargs.insert(0,"lammps") - narg = len(cmdargs) - for i in range(narg): - if type(cmdargs[i]) is str: - cmdargs[i] = cmdargs[i].encode() - cargs = (c_char_p*narg)(*cmdargs) - self.lib.lammps_open.argtypes = [c_int, c_char_p*narg, MPI_Comm, c_void_p] - else: - self.lib.lammps_open.argtypes = [c_int, c_char_p, MPI_Comm, c_void_p] - - self.opened = 1 - comm_ptr = self.MPI._addressof(comm) - comm_val = MPI_Comm.from_address(comm_ptr) - self.lmp = c_void_p(self.lib.lammps_open(narg,cargs,comm_val,None)) - - else: - if self.has_mpi4py and self.has_mpi_support: - self.comm = self.MPI.COMM_WORLD - self.opened = 1 - if cmdargs is not None: - cmdargs.insert(0,"lammps") - narg = len(cmdargs) - for i in range(narg): - if type(cmdargs[i]) is str: - cmdargs[i] = cmdargs[i].encode() - cargs = (c_char_p*narg)(*cmdargs) - self.lib.lammps_open_no_mpi.argtypes = [c_int, c_char_p*narg, c_void_p] - self.lmp = c_void_p(self.lib.lammps_open_no_mpi(narg,cargs,None)) - else: - self.lib.lammps_open_no_mpi.argtypes = [c_int, c_char_p, c_void_p] - self.lmp = c_void_p(self.lib.lammps_open_no_mpi(0,None,None)) - - else: - # magic to convert ptr to ctypes ptr - if sys.version_info >= (3, 0): - # Python 3 (uses PyCapsule API) - pythonapi.PyCapsule_GetPointer.restype = c_void_p - pythonapi.PyCapsule_GetPointer.argtypes = [py_object, c_char_p] - self.lmp = c_void_p(pythonapi.PyCapsule_GetPointer(ptr, None)) - else: - # Python 2 (uses PyCObject API) - pythonapi.PyCObject_AsVoidPtr.restype = c_void_p - pythonapi.PyCObject_AsVoidPtr.argtypes = [py_object] - self.lmp = c_void_p(pythonapi.PyCObject_AsVoidPtr(ptr)) - - # check if library initilialization failed - if not self.lmp: - raise(RuntimeError("Failed to initialize LAMMPS object")) - - # optional numpy support (lazy loading) - self._numpy = None - - self._installed_packages = None - self._available_styles = None - - # check if liblammps version matches the installed python module version - # but not for in-place usage, i.e. when the version is 0 - import lammps - if lammps.__version__ > 0 and lammps.__version__ != self.lib.lammps_version(self.lmp): - raise(AttributeError("LAMMPS Python module installed for LAMMPS version %d, but shared library is version %d" \ - % (lammps.__version__, self.lib.lammps_version(self.lmp)))) - - # add way to insert Python callback for fix external - self.callback = {} - self.FIX_EXTERNAL_CALLBACK_FUNC = CFUNCTYPE(None, py_object, self.c_bigint, c_int, POINTER(self.c_tagint), POINTER(POINTER(c_double)), POINTER(POINTER(c_double))) - self.lib.lammps_set_fix_external_callback.argtypes = [c_void_p, c_char_p, self.FIX_EXTERNAL_CALLBACK_FUNC, py_object] - self.lib.lammps_set_fix_external_callback.restype = None - - # ------------------------------------------------------------------------- - # shut-down LAMMPS instance - - def __del__(self): - self.close() - - # ------------------------------------------------------------------------- - # context manager implementation - - def __enter__(self): - return self - - def __exit__(self, ex_type, ex_value, ex_traceback): - self.close() - - # ------------------------------------------------------------------------- - - @property - def numpy(self): - """ Return object to access numpy versions of API - - It provides alternative implementations of API functions that - return numpy arrays instead of ctypes pointers. If numpy is not installed, - accessing this property will lead to an ImportError. - - :return: instance of numpy wrapper object - :rtype: numpy_wrapper - """ - if not self._numpy: - from .numpy_wrapper import numpy_wrapper - self._numpy = numpy_wrapper(self) - return self._numpy - - # ------------------------------------------------------------------------- - - def close(self): - """Explicitly delete a LAMMPS instance through the C-library interface. - - This is a wrapper around the :cpp:func:`lammps_close` function of the C-library interface. - """ - if self.lmp and self.opened: - self.lib.lammps_close(self.lmp) - self.lmp = None - self.opened = 0 - - # ------------------------------------------------------------------------- - - def finalize(self): - """Shut down the MPI communication and Kokkos environment (if active) through the - library interface by calling :cpp:func:`lammps_mpi_finalize` and - :cpp:func:`lammps_kokkos_finalize`. - - You cannot create or use any LAMMPS instances after this function is called - unless LAMMPS was compiled without MPI and without Kokkos support. - """ - self.close() - self.lib.lammps_kokkos_finalize() - self.lib.lammps_mpi_finalize() - - # ------------------------------------------------------------------------- - - def version(self): - """Return a numerical representation of the LAMMPS version in use. - - This is a wrapper around the :cpp:func:`lammps_version` function of the C-library interface. - - :return: version number - :rtype: int - """ - return self.lib.lammps_version(self.lmp) - - # ------------------------------------------------------------------------- - - def get_os_info(self): - """Return a string with information about the OS and compiler runtime - - This is a wrapper around the :cpp:func:`lammps_get_os_info` function of the C-library interface. - - :return: OS info string - :rtype: string - """ - - sb = create_string_buffer(512) - self.lib.lammps_get_os_info(sb,512) - return sb.value.decode() - - # ------------------------------------------------------------------------- - - def get_mpi_comm(self): - """Get the MPI communicator in use by the current LAMMPS instance - - This is a wrapper around the :cpp:func:`lammps_get_mpi_comm` function - of the C-library interface. It will return ``None`` if either the - LAMMPS library was compiled without MPI support or the mpi4py - Python module is not available. - - :return: MPI communicator - :rtype: MPI_Comm - """ - - if self.has_mpi4py and self.has_mpi_support: - from mpi4py import MPI - f_comm = self.lib.lammps_get_mpi_comm(self.lmp) - c_comm = MPI.Comm.f2py(f_comm) - return c_comm - else: - return None - - # ------------------------------------------------------------------------- - - @property - def _lammps_exception(self): - sb = create_string_buffer(100) - error_type = self.lib.lammps_get_last_error_message(self.lmp, sb, 100) - error_msg = sb.value.decode().strip() - - if error_type == 2: - return MPIAbortException(error_msg) - return Exception(error_msg) - - # ------------------------------------------------------------------------- - - def file(self, path): - """Read LAMMPS commands from a file. - - This is a wrapper around the :cpp:func:`lammps_file` function of the C-library interface. - It will open the file with the name/path `file` and process the LAMMPS commands line by line until - the end. The function will return when the end of the file is reached. - - :param path: Name of the file/path with LAMMPS commands - :type path: string - """ - if path: path = path.encode() - else: return - - with ExceptionCheck(self): - self.lib.lammps_file(self.lmp, path) - - # ------------------------------------------------------------------------- - - def command(self,cmd): - """Process a single LAMMPS input command from a string. - - This is a wrapper around the :cpp:func:`lammps_command` - function of the C-library interface. - - :param cmd: a single lammps command - :type cmd: string - """ - if cmd: cmd = cmd.encode() - else: return - - with ExceptionCheck(self): - self.lib.lammps_command(self.lmp,cmd) - - # ------------------------------------------------------------------------- - - def commands_list(self,cmdlist): - """Process multiple LAMMPS input commands from a list of strings. - - This is a wrapper around the - :cpp:func:`lammps_commands_list` function of - the C-library interface. - - :param cmdlist: a single lammps command - :type cmdlist: list of strings - """ - cmds = [x.encode() for x in cmdlist if type(x) is str] - narg = len(cmdlist) - args = (c_char_p * narg)(*cmds) - self.lib.lammps_commands_list.argtypes = [c_void_p, c_int, c_char_p * narg] - - with ExceptionCheck(self): - self.lib.lammps_commands_list(self.lmp,narg,args) - - # ------------------------------------------------------------------------- - - def commands_string(self,multicmd): - """Process a block of LAMMPS input commands from a string. - - This is a wrapper around the - :cpp:func:`lammps_commands_string` - function of the C-library interface. - - :param multicmd: text block of lammps commands - :type multicmd: string - """ - if type(multicmd) is str: multicmd = multicmd.encode() - - with ExceptionCheck(self): - self.lib.lammps_commands_string(self.lmp,c_char_p(multicmd)) - - # ------------------------------------------------------------------------- - - def get_natoms(self): - """Get the total number of atoms in the LAMMPS instance. - - Will be precise up to 53-bit signed integer due to the - underlying :cpp:func:`lammps_get_natoms` function returning a double. - - :return: number of atoms - :rtype: int - """ - return int(self.lib.lammps_get_natoms(self.lmp)) - - # ------------------------------------------------------------------------- - - def extract_box(self): - """Extract simulation box parameters - - This is a wrapper around the :cpp:func:`lammps_extract_box` function - of the C-library interface. Unlike in the C function, the result is - returned as a list. - - :return: list of the extracted data: boxlo, boxhi, xy, yz, xz, periodicity, box_change - :rtype: [ 3*double, 3*double, double, double, 3*int, int] - """ - boxlo = (3*c_double)() - boxhi = (3*c_double)() - xy = c_double() - yz = c_double() - xz = c_double() - periodicity = (3*c_int)() - box_change = c_int() - - with ExceptionCheck(self): - self.lib.lammps_extract_box(self.lmp,boxlo,boxhi, - byref(xy),byref(yz),byref(xz), - periodicity,byref(box_change)) - - boxlo = boxlo[:3] - boxhi = boxhi[:3] - xy = xy.value - yz = yz.value - xz = xz.value - periodicity = periodicity[:3] - box_change = box_change.value - - return boxlo,boxhi,xy,yz,xz,periodicity,box_change - - # ------------------------------------------------------------------------- - - def reset_box(self,boxlo,boxhi,xy,yz,xz): - """Reset simulation box parameters - - This is a wrapper around the :cpp:func:`lammps_reset_box` function - of the C-library interface. - - :param boxlo: new lower box boundaries - :type boxlo: list of 3 floating point numbers - :param boxhi: new upper box boundaries - :type boxhi: list of 3 floating point numbers - :param xy: xy tilt factor - :type xy: float - :param yz: yz tilt factor - :type yz: float - :param xz: xz tilt factor - :type xz: float - """ - cboxlo = (3*c_double)(*boxlo) - cboxhi = (3*c_double)(*boxhi) - with ExceptionCheck(self): - self.lib.lammps_reset_box(self.lmp,cboxlo,cboxhi,xy,yz,xz) - - # ------------------------------------------------------------------------- - - def get_thermo(self,name): - """Get current value of a thermo keyword - - This is a wrapper around the :cpp:func:`lammps_get_thermo` - function of the C-library interface. - - :param name: name of thermo keyword - :type name: string - :return: value of thermo keyword - :rtype: double or None - """ - if name: name = name.encode() - else: return None - - with ExceptionCheck(self): - return self.lib.lammps_get_thermo(self.lmp,name) - - # ------------------------------------------------------------------------- - - def extract_setting(self, name): - """Query LAMMPS about global settings that can be expressed as an integer. - - This is a wrapper around the :cpp:func:`lammps_extract_setting` - function of the C-library interface. Its documentation includes - a list of the supported keywords. - - :param name: name of the setting - :type name: string - :return: value of the setting - :rtype: int - """ - if name: name = name.encode() - else: return None - return int(self.lib.lammps_extract_setting(self.lmp,name)) - - # ------------------------------------------------------------------------- - # extract global info datatype - - def extract_global_datatype(self, name): - """Retrieve global property datatype from LAMMPS - - This is a wrapper around the :cpp:func:`lammps_extract_global_datatype` - function of the C-library interface. Its documentation includes a - list of the supported keywords. - This function returns ``None`` if the keyword is not - recognized. Otherwise it will return a positive integer value that - corresponds to one of the :ref:`data type ` - constants define in the :py:mod:`lammps` module. - - :param name: name of the property - :type name: string - :return: data type of global property, see :ref:`py_datatype_constants` - :rtype: int - """ - if name: name = name.encode() - else: return None - return self.lib.lammps_extract_global_datatype(self.lmp, name) - - # ------------------------------------------------------------------------- - # extract global info - - def extract_global(self, name, dtype=LAMMPS_AUTODETECT): - """Query LAMMPS about global settings of different types. - - This is a wrapper around the :cpp:func:`lammps_extract_global` function - of the C-library interface. Since there are no pointers in Python, this - method will - unlike the C function - return the value or a list of - values. The :cpp:func:`lammps_extract_global` documentation includes a - list of the supported keywords and their data types. - Since Python needs to know the data type to be able to interpret - the result, by default, this function will try to auto-detect the data type - by asking the library. You can also force a specific data type. For that - purpose the :py:mod:`lammps` module contains :ref:`data type ` - constants. This function returns ``None`` if either the keyword is not recognized, - or an invalid data type constant is used. - - :param name: name of the property - :type name: string - :param dtype: data type of the returned data (see :ref:`py_datatype_constants`) - :type dtype: int, optional - :return: value of the property or list of values or None - :rtype: int, float, list, or NoneType - """ - - if dtype == LAMMPS_AUTODETECT: - dtype = self.extract_global_datatype(name) - - # set length of vector for items that are not a scalar - vec_dict = { 'boxlo':3, 'boxhi':3, 'sublo':3, 'subhi':3, - 'sublo_lambda':3, 'subhi_lambda':3, 'periodicity':3 } - if name in vec_dict: - veclen = vec_dict[name] - elif name == 'respa_dt': - veclen = self.extract_global('respa_levels',LAMMPS_INT) - else: - veclen = 1 - - if name: name = name.encode() - else: return None - - if dtype == LAMMPS_INT: - self.lib.lammps_extract_global.restype = POINTER(c_int32) - target_type = int - elif dtype == LAMMPS_INT64: - self.lib.lammps_extract_global.restype = POINTER(c_int64) - target_type = int - elif dtype == LAMMPS_DOUBLE: - self.lib.lammps_extract_global.restype = POINTER(c_double) - target_type = float - elif dtype == LAMMPS_STRING: - self.lib.lammps_extract_global.restype = c_char_p - target_type = str - else: - target_type = None - - ptr = self.lib.lammps_extract_global(self.lmp, name) - if ptr: - if dtype == LAMMPS_STRING: - return ptr.decode('utf-8') - if veclen > 1: - result = [] - for i in range(0,veclen): - result.append(target_type(ptr[i])) - return result - else: return target_type(ptr[0]) - return None - - # ------------------------------------------------------------------------- - # extract per-atom info datatype - - def extract_atom_datatype(self, name): - """Retrieve per-atom property datatype from LAMMPS - - This is a wrapper around the :cpp:func:`lammps_extract_atom_datatype` - function of the C-library interface. Its documentation includes a - list of the supported keywords. - This function returns ``None`` if the keyword is not - recognized. Otherwise it will return an integer value that - corresponds to one of the :ref:`data type ` constants - defined in the :py:mod:`lammps` module. - - :param name: name of the property - :type name: string - :return: data type of per-atom property (see :ref:`py_datatype_constants`) - :rtype: int - """ - if name: name = name.encode() - else: return None - return self.lib.lammps_extract_atom_datatype(self.lmp, name) - - # ------------------------------------------------------------------------- - # extract per-atom info - - def extract_atom(self, name, dtype=LAMMPS_AUTODETECT): - """Retrieve per-atom properties from LAMMPS - - This is a wrapper around the :cpp:func:`lammps_extract_atom` - function of the C-library interface. Its documentation includes a - list of the supported keywords and their data types. - Since Python needs to know the data type to be able to interpret - the result, by default, this function will try to auto-detect the data type - by asking the library. You can also force a specific data type by setting ``dtype`` - to one of the :ref:`data type ` constants defined in the - :py:mod:`lammps` module. - This function returns ``None`` if either the keyword is not - recognized, or an invalid data type constant is used. - - .. note:: - - While the returned arrays of per-atom data are dimensioned - for the range [0:nmax] - as is the underlying storage - - the data is usually only valid for the range of [0:nlocal], - unless the property of interest is also updated for ghost - atoms. In some cases, this depends on a LAMMPS setting, see - for example :doc:`comm_modify vel yes `. - - :param name: name of the property - :type name: string - :param dtype: data type of the returned data (see :ref:`py_datatype_constants`) - :type dtype: int, optional - :return: requested data or ``None`` - :rtype: ctypes.POINTER(ctypes.c_int32), ctypes.POINTER(ctypes.POINTER(ctypes.c_int32)), - ctypes.POINTER(ctypes.c_int64), ctypes.POINTER(ctypes.POINTER(ctypes.c_int64)), - ctypes.POINTER(ctypes.c_double), ctypes.POINTER(ctypes.POINTER(ctypes.c_double)), - or NoneType - """ - if dtype == LAMMPS_AUTODETECT: - dtype = self.extract_atom_datatype(name) - - if name: name = name.encode() - else: return None - - if dtype == LAMMPS_INT: - self.lib.lammps_extract_atom.restype = POINTER(c_int32) - elif dtype == LAMMPS_INT_2D: - self.lib.lammps_extract_atom.restype = POINTER(POINTER(c_int32)) - elif dtype == LAMMPS_DOUBLE: - self.lib.lammps_extract_atom.restype = POINTER(c_double) - elif dtype == LAMMPS_DOUBLE_2D: - self.lib.lammps_extract_atom.restype = POINTER(POINTER(c_double)) - elif dtype == LAMMPS_INT64: - self.lib.lammps_extract_atom.restype = POINTER(c_int64) - elif dtype == LAMMPS_INT64_2D: - self.lib.lammps_extract_atom.restype = POINTER(POINTER(c_int64)) - else: return None - - ptr = self.lib.lammps_extract_atom(self.lmp, name) - if ptr: return ptr - else: return None - - - # ------------------------------------------------------------------------- - - def extract_compute(self,cid,cstyle,ctype): - """Retrieve data from a LAMMPS compute - - This is a wrapper around the :cpp:func:`lammps_extract_compute` - function of the C-library interface. - This function returns ``None`` if either the compute id is not - recognized, or an invalid combination of :ref:`cstyle ` - and :ref:`ctype ` constants is used. The - names and functionality of the constants are the same as for - the corresponding C-library function. For requests to return - a scalar or a size, the value is returned, otherwise a pointer. - - :param cid: compute ID - :type cid: string - :param cstyle: style of the data retrieve (global, atom, or local), see :ref:`py_style_constants` - :type cstyle: int - :param ctype: type or size of the returned data (scalar, vector, or array), see :ref:`py_type_constants` - :type ctype: int - :return: requested data as scalar, pointer to 1d or 2d double array, or None - :rtype: c_double, ctypes.POINTER(c_double), ctypes.POINTER(ctypes.POINTER(c_double)), or NoneType - """ - if cid: cid = cid.encode() - else: return None - - if ctype == LMP_TYPE_SCALAR: - if cstyle == LMP_STYLE_GLOBAL: - self.lib.lammps_extract_compute.restype = POINTER(c_double) - with ExceptionCheck(self): - ptr = self.lib.lammps_extract_compute(self.lmp,cid,cstyle,ctype) - return ptr[0] - elif cstyle == LMP_STYLE_ATOM: - return None - elif cstyle == LMP_STYLE_LOCAL: - self.lib.lammps_extract_compute.restype = POINTER(c_int) - with ExceptionCheck(self): - ptr = self.lib.lammps_extract_compute(self.lmp,cid,cstyle,ctype) - return ptr[0] - - elif ctype == LMP_TYPE_VECTOR: - self.lib.lammps_extract_compute.restype = POINTER(c_double) - with ExceptionCheck(self): - ptr = self.lib.lammps_extract_compute(self.lmp,cid,cstyle,ctype) - return ptr - - elif ctype == LMP_TYPE_ARRAY: - self.lib.lammps_extract_compute.restype = POINTER(POINTER(c_double)) - with ExceptionCheck(self): - ptr = self.lib.lammps_extract_compute(self.lmp,cid,cstyle,ctype) - return ptr - - elif ctype == LMP_SIZE_COLS: - if cstyle == LMP_STYLE_GLOBAL or cstyle == LMP_STYLE_ATOM or cstyle == LMP_STYLE_LOCAL: - self.lib.lammps_extract_compute.restype = POINTER(c_int) - with ExceptionCheck(self): - ptr = self.lib.lammps_extract_compute(self.lmp,cid,cstyle,ctype) - return ptr[0] - - elif ctype == LMP_SIZE_VECTOR or ctype == LMP_SIZE_ROWS: - if cstyle == LMP_STYLE_GLOBAL or cstyle == LMP_STYLE_LOCAL: - self.lib.lammps_extract_compute.restype = POINTER(c_int) - with ExceptionCheck(self): - ptr = self.lib.lammps_extract_compute(self.lmp,cid,cstyle,ctype) - return ptr[0] - - return None - - # ------------------------------------------------------------------------- - # extract fix info - # in case of global data, free memory for 1 double via lammps_free() - # double was allocated by library interface function - - def extract_fix(self,fid,fstyle,ftype,nrow=0,ncol=0): - """Retrieve data from a LAMMPS fix - - This is a wrapper around the :cpp:func:`lammps_extract_fix` - function of the C-library interface. - This function returns ``None`` if either the fix id is not - recognized, or an invalid combination of :ref:`fstyle ` - and :ref:`ftype ` constants is used. The - names and functionality of the constants are the same as for - the corresponding C-library function. For requests to return - a scalar or a size, the value is returned, also when accessing - global vectors or arrays, otherwise a pointer. - - :param fid: fix ID - :type fid: string - :param fstyle: style of the data retrieve (global, atom, or local), see :ref:`py_style_constants` - :type fstyle: int - :param ftype: type or size of the returned data (scalar, vector, or array), see :ref:`py_type_constants` - :type ftype: int - :param nrow: index of global vector element or row index of global array element - :type nrow: int - :param ncol: column index of global array element - :type ncol: int - :return: requested data or None - :rtype: c_double, ctypes.POINTER(c_double), ctypes.POINTER(ctypes.POINTER(c_double)), or NoneType - - """ - if fid: fid = fid.encode() - else: return None - - if fstyle == LMP_STYLE_GLOBAL: - if ftype in (LMP_TYPE_SCALAR, LMP_TYPE_VECTOR, LMP_TYPE_ARRAY): - self.lib.lammps_extract_fix.restype = POINTER(c_double) - with ExceptionCheck(self): - ptr = self.lib.lammps_extract_fix(self.lmp,fid,fstyle,ftype,nrow,ncol) - result = ptr[0] - self.lib.lammps_free(ptr) - return result - elif ftype in (LMP_SIZE_VECTOR, LMP_SIZE_ROWS, LMP_SIZE_COLS): - self.lib.lammps_extract_fix.restype = POINTER(c_int) - with ExceptionCheck(self): - ptr = self.lib.lammps_extract_fix(self.lmp,fid,fstyle,ftype,nrow,ncol) - return ptr[0] - else: - return None - - elif fstyle == LMP_STYLE_ATOM: - if ftype == LMP_TYPE_VECTOR: - self.lib.lammps_extract_fix.restype = POINTER(c_double) - elif ftype == LMP_TYPE_ARRAY: - self.lib.lammps_extract_fix.restype = POINTER(POINTER(c_double)) - elif ftype == LMP_SIZE_COLS: - self.lib.lammps_extract_fix.restype = POINTER(c_int) - else: - return None - with ExceptionCheck(self): - ptr = self.lib.lammps_extract_fix(self.lmp,fid,fstyle,ftype,nrow,ncol) - if ftype == LMP_SIZE_COLS: - return ptr[0] - else: - return ptr - - elif fstyle == LMP_STYLE_LOCAL: - if ftype == LMP_TYPE_VECTOR: - self.lib.lammps_extract_fix.restype = POINTER(c_double) - elif ftype == LMP_TYPE_ARRAY: - self.lib.lammps_extract_fix.restype = POINTER(POINTER(c_double)) - elif ftype in (LMP_TYPE_SCALAR, LMP_SIZE_VECTOR, LMP_SIZE_ROWS, LMP_SIZE_COLS): - self.lib.lammps_extract_fix.restype = POINTER(c_int) - else: - return None - with ExceptionCheck(self): - ptr = self.lib.lammps_extract_fix(self.lmp,fid,fstyle,ftype,nrow,ncol) - if ftype in (LMP_TYPE_VECTOR, LMP_TYPE_ARRAY): - return ptr - else: - return ptr[0] - else: - return None - - # ------------------------------------------------------------------------- - # extract variable info - # free memory for 1 double or 1 vector of doubles via lammps_free() - # for vector, must copy nlocal returned values to local c_double vector - # memory was allocated by library interface function - - def extract_variable(self, name, group=None, vartype=LMP_VAR_EQUAL): - """ Evaluate a LAMMPS variable and return its data - - This function is a wrapper around the function - :cpp:func:`lammps_extract_variable` of the C-library interface, - evaluates variable name and returns a copy of the computed data. - The memory temporarily allocated by the C-interface is deleted - after the data is copied to a Python variable or list. - The variable must be either an equal-style (or equivalent) - variable or an atom-style variable. The variable type has to - provided as ``vartype`` parameter which may be one of two constants: - ``LMP_VAR_EQUAL`` or ``LMP_VAR_ATOM``; it defaults to - equal-style variables. - The group parameter is only used for atom-style variables and - defaults to the group "all" if set to ``None``, which is the default. - - :param name: name of the variable to execute - :type name: string - :param group: name of group for atom-style variable - :type group: string, only for atom-style variables - :param vartype: type of variable, see :ref:`py_vartype_constants` - :type vartype: int - :return: the requested data - :rtype: c_double, (c_double), or NoneType - """ - if name: name = name.encode() - else: return None - if group: group = group.encode() - if vartype == LMP_VAR_EQUAL: - self.lib.lammps_extract_variable.restype = POINTER(c_double) - with ExceptionCheck(self): - ptr = self.lib.lammps_extract_variable(self.lmp,name,group) - if ptr: result = ptr[0] - else: return None - self.lib.lammps_free(ptr) - return result - elif vartype == LMP_VAR_ATOM: - nlocal = self.extract_global("nlocal") - result = (c_double*nlocal)() - self.lib.lammps_extract_variable.restype = POINTER(c_double) - with ExceptionCheck(self): - ptr = self.lib.lammps_extract_variable(self.lmp,name,group) - if ptr: - for i in range(nlocal): result[i] = ptr[i] - self.lib.lammps_free(ptr) - else: return None - return result - return None - - # ------------------------------------------------------------------------- - - def flush_buffers(self): - """Flush output buffers - - This is a wrapper around the :cpp:func:`lammps_flush_buffers` - function of the C-library interface. - """ - self.lib.lammps_flush_buffers(self.lmp) - - # ------------------------------------------------------------------------- - - def set_variable(self,name,value): - """Set a new value for a LAMMPS string style variable - - This is a wrapper around the :cpp:func:`lammps_set_variable` - function of the C-library interface. - - :param name: name of the variable - :type name: string - :param value: new variable value - :type value: any. will be converted to a string - :return: either 0 on success or -1 on failure - :rtype: int - """ - if name: name = name.encode() - else: return -1 - if value: value = str(value).encode() - else: return -1 - with ExceptionCheck(self): - return self.lib.lammps_set_variable(self.lmp,name,value) - - # ------------------------------------------------------------------------- - - # return vector of atom properties gathered across procs - # 3 variants to match src/library.cpp - # name = atom property recognized by LAMMPS in atom->extract() - # dtype = 0 for integer values, 1 for double values - # count = number of per-atom valus, 1 for type or charge, 3 for x or f - # returned data is a 1d vector - doc how it is ordered? - # NOTE: need to insure are converting to/from correct Python type - # e.g. for Python list or NumPy or ctypes - - def gather_atoms(self,name,dtype,count): - if name: name = name.encode() - natoms = self.get_natoms() - with ExceptionCheck(self): - if dtype == 0: - data = ((count*natoms)*c_int)() - self.lib.lammps_gather_atoms(self.lmp,name,dtype,count,data) - elif dtype == 1: - data = ((count*natoms)*c_double)() - self.lib.lammps_gather_atoms(self.lmp,name,dtype,count,data) - else: - return None - return data - - # ------------------------------------------------------------------------- - - def gather_atoms_concat(self,name,dtype,count): - if name: name = name.encode() - natoms = self.get_natoms() - with ExceptionCheck(self): - if dtype == 0: - data = ((count*natoms)*c_int)() - self.lib.lammps_gather_atoms_concat(self.lmp,name,dtype,count,data) - elif dtype == 1: - data = ((count*natoms)*c_double)() - self.lib.lammps_gather_atoms_concat(self.lmp,name,dtype,count,data) - else: - return None - return data - - def gather_atoms_subset(self,name,dtype,count,ndata,ids): - if name: name = name.encode() - with ExceptionCheck(self): - if dtype == 0: - data = ((count*ndata)*c_int)() - self.lib.lammps_gather_atoms_subset(self.lmp,name,dtype,count,ndata,ids,data) - elif dtype == 1: - data = ((count*ndata)*c_double)() - self.lib.lammps_gather_atoms_subset(self.lmp,name,dtype,count,ndata,ids,data) - else: - return None - return data - - # ------------------------------------------------------------------------- - - # scatter vector of atom properties across procs - # 2 variants to match src/library.cpp - # name = atom property recognized by LAMMPS in atom->extract() - # type = 0 for integer values, 1 for double values - # count = number of per-atom valus, 1 for type or charge, 3 for x or f - # assume data is of correct type and length, as created by gather_atoms() - # NOTE: need to insure are converting to/from correct Python type - # e.g. for Python list or NumPy or ctypes - - def scatter_atoms(self,name,dtype,count,data): - if name: name = name.encode() - with ExceptionCheck(self): - self.lib.lammps_scatter_atoms(self.lmp,name,dtype,count,data) - - # ------------------------------------------------------------------------- - - def scatter_atoms_subset(self,name,dtype,count,ndata,ids,data): - if name: name = name.encode() - with ExceptionCheck(self): - self.lib.lammps_scatter_atoms_subset(self.lmp,name,dtype,count,ndata,ids,data) - - - # ------------------------------------------------------------------------- - - def gather_bonds(self): - """Retrieve global list of bonds - - This is a wrapper around the :cpp:func:`lammps_gather_bonds` - function of the C-library interface. - - This function returns a tuple with the number of bonds and a - flat list of ctypes integer values with the bond type, bond atom1, - bond atom2 for each bond. - - .. versionadded:: 28Jul2021 - - :return: a tuple with the number of bonds and a list of c_int or c_long - :rtype: (int, 3*nbonds*c_tagint) - """ - nbonds = self.extract_global("nbonds") - with ExceptionCheck(self): - data = ((3*nbonds)*self.c_tagint)() - self.lib.lammps_gather_bonds(self.lmp,data) - return nbonds,data - - # ------------------------------------------------------------------------- - - # return vector of atom/compute/fix properties gathered across procs - # 3 variants to match src/library.cpp - # name = atom property recognized by LAMMPS in atom->extract() - # type = 0 for integer values, 1 for double values - # count = number of per-atom valus, 1 for type or charge, 3 for x or f - # returned data is a 1d vector - doc how it is ordered? - # NOTE: need to insure are converting to/from correct Python type - # e.g. for Python list or NumPy or ctypes - def gather(self,name,dtype,count): - if name: name = name.encode() - natoms = self.get_natoms() - with ExceptionCheck(self): - if dtype == 0: - data = ((count*natoms)*c_int)() - self.lib.lammps_gather(self.lmp,name,dtype,count,data) - elif dtype == 1: - data = ((count*natoms)*c_double)() - self.lib.lammps_gather(self.lmp,name,dtype,count,data) - else: - return None - return data - - def gather_concat(self,name,dtype,count): - if name: name = name.encode() - natoms = self.get_natoms() - with ExceptionCheck(self): - if dtype == 0: - data = ((count*natoms)*c_int)() - self.lib.lammps_gather_concat(self.lmp,name,dtype,count,data) - elif dtype == 1: - data = ((count*natoms)*c_double)() - self.lib.lammps_gather_concat(self.lmp,name,dtype,count,data) - else: - return None - return data - - def gather_subset(self,name,dtype,count,ndata,ids): - if name: name = name.encode() - with ExceptionCheck(self): - if dtype == 0: - data = ((count*ndata)*c_int)() - self.lib.lammps_gather_subset(self.lmp,name,dtype,count,ndata,ids,data) - elif dtype == 1: - data = ((count*ndata)*c_double)() - self.lib.lammps_gather_subset(self.lmp,name,dtype,count,ndata,ids,data) - else: - return None - return data - - # scatter vector of atom/compute/fix properties across procs - # 2 variants to match src/library.cpp - # name = atom property recognized by LAMMPS in atom->extract() - # type = 0 for integer values, 1 for double values - # count = number of per-atom valus, 1 for type or charge, 3 for x or f - # assume data is of correct type and length, as created by gather_atoms() - # NOTE: need to insure are converting to/from correct Python type - # e.g. for Python list or NumPy or ctypes - - def scatter(self,name,dtype,count,data): - if name: name = name.encode() - with ExceptionCheck(self): - self.lib.lammps_scatter(self.lmp,name,dtype,count,data) - - def scatter_subset(self,name,dtype,count,ndata,ids,data): - if name: name = name.encode() - with ExceptionCheck(self): - self.lib.lammps_scatter_subset(self.lmp,name,dtype,count,ndata,ids,data) - - # ------------------------------------------------------------------------- - - def encode_image_flags(self,ix,iy,iz): - """ convert 3 integers with image flags for x-, y-, and z-direction - into a single integer like it is used internally in LAMMPS - - This method is a wrapper around the :cpp:func:`lammps_encode_image_flags` - function of library interface. - - :param ix: x-direction image flag - :type ix: int - :param iy: y-direction image flag - :type iy: int - :param iz: z-direction image flag - :type iz: int - :return: encoded image flags - :rtype: lammps.c_imageint - """ - return self.lib.lammps_encode_image_flags(ix,iy,iz) - - # ------------------------------------------------------------------------- - - def decode_image_flags(self,image): - """ Convert encoded image flag integer into list of three regular integers. - - This method is a wrapper around the :cpp:func:`lammps_decode_image_flags` - function of library interface. - - :param image: encoded image flags - :type image: lammps.c_imageint - :return: list of three image flags in x-, y-, and z- direction - :rtype: list of 3 int - """ - - flags = (c_int*3)() - self.lib.lammps_decode_image_flags(image,byref(flags)) - - return [int(i) for i in flags] - - # ------------------------------------------------------------------------- - - # create N atoms on all procs - # N = global number of atoms - # id = ID of each atom (optional, can be None) - # type = type of each atom (1 to Ntypes) (required) - # x = coords of each atom as (N,3) array (required) - # v = velocity of each atom as (N,3) array (optional, can be None) - # NOTE: how could we insure are passing correct type to LAMMPS - # e.g. for Python list or NumPy, etc - # ditto for gather_atoms() above - - def create_atoms(self,n,id,type,x,v=None,image=None,shrinkexceed=False): - """ - Create N atoms from list of coordinates and properties - - This function is a wrapper around the :cpp:func:`lammps_create_atoms` - function of the C-library interface, and the behavior is similar except - that the *v*, *image*, and *shrinkexceed* arguments are optional and - default to *None*, *None*, and *False*, respectively. With *None* being - equivalent to a ``NULL`` pointer in C. - - The lists of coordinates, types, atom IDs, velocities, image flags can - be provided in any format that may be converted into the required - internal data types. Also the list may contain more than *N* entries, - but not fewer. In the latter case, the function will return without - attempting to create atoms. You may use the :py:func:`encode_image_flags - ` method to properly combine three integers - with image flags into a single integer. - - :param n: number of atoms for which data is provided - :type n: int - :param id: list of atom IDs with at least n elements or None - :type id: list of lammps.tagint - :param type: list of atom types - :type type: list of int - :param x: list of coordinates for x-, y-, and z (flat list of 3n entries) - :type x: list of float - :param v: list of velocities for x-, y-, and z (flat list of 3n entries) or None (optional) - :type v: list of float - :param image: list of encoded image flags (optional) - :type image: list of lammps.imageint - :param shrinkexceed: whether to expand shrink-wrap boundaries if atoms are outside the box (optional) - :type shrinkexceed: bool - :return: number of atoms created. 0 if insufficient or invalid data - :rtype: int - """ - if id is not None: - id_lmp = (self.c_tagint*n)() - try: - id_lmp[:] = id[0:n] - except ValueError: - return 0 - else: - id_lmp = None - - type_lmp = (c_int*n)() - try: - type_lmp[:] = type[0:n] - except ValueError: - return 0 - - three_n = 3*n - x_lmp = (c_double*three_n)() - try: - x_lmp[:] = x[0:three_n] - except ValueError: - return 0 - - if v is not None: - v_lmp = (c_double*(three_n))() - try: - v_lmp[:] = v[0:three_n] - except ValueError: - return 0 - else: - v_lmp = None - - if image is not None: - img_lmp = (self.c_imageint*n)() - try: - img_lmp[:] = image[0:n] - except ValueError: - return 0 - else: - img_lmp = None - - if shrinkexceed: - se_lmp = 1 - else: - se_lmp = 0 - - self.lib.lammps_create_atoms.argtypes = [c_void_p, c_int, POINTER(self.c_tagint*n), - POINTER(c_int*n), POINTER(c_double*three_n), - POINTER(c_double*three_n), - POINTER(self.c_imageint*n), c_int] - with ExceptionCheck(self): - return self.lib.lammps_create_atoms(self.lmp, n, id_lmp, type_lmp, x_lmp, v_lmp, img_lmp, se_lmp) - - # ------------------------------------------------------------------------- - - @property - def has_mpi_support(self): - """ Report whether the LAMMPS shared library was compiled with a - real MPI library or in serial. - - This is a wrapper around the :cpp:func:`lammps_config_has_mpi_support` - function of the library interface. - - :return: False when compiled with MPI STUBS, otherwise True - :rtype: bool - """ - return self.lib.lammps_config_has_mpi_support() != 0 - - # ------------------------------------------------------------------------- - - @property - def is_running(self): - """ Report whether being called from a function during a run or a minimization - - Various LAMMPS commands must not be called during an ongoing - run or minimization. This property allows to check for that. - This is a wrapper around the :cpp:func:`lammps_is_running` - function of the library interface. - - .. versionadded:: 9Oct2020 - - :return: True when called during a run otherwise false - :rtype: bool - """ - return self.lib.lammps_is_running(self.lmp) == 1 - - # ------------------------------------------------------------------------- - - def force_timeout(self): - """ Trigger an immediate timeout, i.e. a "soft stop" of a run. - - This function allows to cleanly stop an ongoing run or minimization - at the next loop iteration. - This is a wrapper around the :cpp:func:`lammps_force_timeout` - function of the library interface. - - .. versionadded:: 9Oct2020 - """ - self.lib.lammps_force_timeout(self.lmp) - - # ------------------------------------------------------------------------- - - @property - def has_exceptions(self): - """ Report whether the LAMMPS shared library was compiled with C++ - exceptions handling enabled - - This is a wrapper around the :cpp:func:`lammps_config_has_exceptions` - function of the library interface. - - :return: state of C++ exception support - :rtype: bool - """ - return self.lib.lammps_config_has_exceptions() != 0 - - # ------------------------------------------------------------------------- - - @property - def has_gzip_support(self): - """ Report whether the LAMMPS shared library was compiled with support - for reading and writing compressed files through ``gzip``. - - This is a wrapper around the :cpp:func:`lammps_config_has_gzip_support` - function of the library interface. - - :return: state of gzip support - :rtype: bool - """ - return self.lib.lammps_config_has_gzip_support() != 0 - - # ------------------------------------------------------------------------- - - @property - def has_png_support(self): - """ Report whether the LAMMPS shared library was compiled with support - for writing images in PNG format. - - This is a wrapper around the :cpp:func:`lammps_config_has_png_support` - function of the library interface. - - :return: state of PNG support - :rtype: bool - """ - return self.lib.lammps_config_has_png_support() != 0 - - # ------------------------------------------------------------------------- - - @property - def has_jpeg_support(self): - """ Report whether the LAMMPS shared library was compiled with support - for writing images in JPEG format. - - This is a wrapper around the :cpp:func:`lammps_config_has_jpeg_support` - function of the library interface. - - :return: state of JPEG support - :rtype: bool - """ - return self.lib.lammps_config_has_jpeg_support() != 0 - - # ------------------------------------------------------------------------- - - @property - def has_ffmpeg_support(self): - """ State of support for writing movies with ``ffmpeg`` in the LAMMPS shared library - - This is a wrapper around the :cpp:func:`lammps_config_has_ffmpeg_support` - function of the library interface. - - :return: state of ffmpeg support - :rtype: bool - """ - return self.lib.lammps_config_has_ffmpeg_support() != 0 - - # ------------------------------------------------------------------------- - - @property - def accelerator_config(self): - """ Return table with available accelerator configuration settings. - - This is a wrapper around the :cpp:func:`lammps_config_accelerator` - function of the library interface which loops over all known packages - and categories and returns enabled features as a nested dictionary - with all enabled settings as list of strings. - - :return: nested dictionary with all known enabled settings as list of strings - :rtype: dictionary - """ - - result = {} - for p in ['GPU', 'KOKKOS', 'INTEL', 'OPENMP']: - result[p] = {} - c = 'api' - result[p][c] = [] - for s in ['cuda', 'hip', 'phi', 'pthreads', 'opencl', 'openmp', 'serial']: - if self.lib.lammps_config_accelerator(p.encode(),c.encode(),s.encode()): - result[p][c].append(s) - c = 'precision' - result[p][c] = [] - for s in ['double', 'mixed', 'single']: - if self.lib.lammps_config_accelerator(p.encode(),c.encode(),s.encode()): - result[p][c].append(s) - return result - - # ------------------------------------------------------------------------- - - @property - def has_gpu_device(self): - """ Availability of GPU package compatible device - - This is a wrapper around the :cpp:func:`lammps_has_gpu_device` - function of the C library interface. - - :return: True if a GPU package compatible device is present, otherwise False - :rtype: bool - """ - return self.lib.lammps_has_gpu_device() != 0 - - # ------------------------------------------------------------------------- - - def get_gpu_device_info(self): - """Return a string with detailed information about any devices that are - usable by the GPU package. - - This is a wrapper around the :cpp:func:`lammps_get_gpu_device_info` - function of the C-library interface. - - :return: GPU device info string - :rtype: string - """ - - sb = create_string_buffer(8192) - self.lib.lammps_get_gpu_device_info(sb,8192) - return sb.value.decode() - - # ------------------------------------------------------------------------- - - @property - def installed_packages(self): - """ List of the names of enabled packages in the LAMMPS shared library - - This is a wrapper around the functions :cpp:func:`lammps_config_package_count` - and :cpp:func`lammps_config_package_name` of the library interface. - - :return - """ - if self._installed_packages is None: - self._installed_packages = [] - npackages = self.lib.lammps_config_package_count() - sb = create_string_buffer(100) - for idx in range(npackages): - self.lib.lammps_config_package_name(idx, sb, 100) - self._installed_packages.append(sb.value.decode()) - return self._installed_packages - - # ------------------------------------------------------------------------- - - def has_style(self, category, name): - """Returns whether a given style name is available in a given category - - This is a wrapper around the function :cpp:func:`lammps_has_style` - of the library interface. - - :param category: name of category - :type category: string - :param name: name of the style - :type name: string - - :return: true if style is available in given category - :rtype: bool - """ - return self.lib.lammps_has_style(self.lmp, category.encode(), name.encode()) != 0 - - # ------------------------------------------------------------------------- - - def available_styles(self, category): - """Returns a list of styles available for a given category - - This is a wrapper around the functions :cpp:func:`lammps_style_count()` - and :cpp:func:`lammps_style_name()` of the library interface. - - :param category: name of category - :type category: string - - :return: list of style names in given category - :rtype: list - """ - if self._available_styles is None: - self._available_styles = {} - - if category not in self._available_styles: - self._available_styles[category] = [] - with ExceptionCheck(self): - nstyles = self.lib.lammps_style_count(self.lmp, category.encode()) - sb = create_string_buffer(100) - for idx in range(nstyles): - with ExceptionCheck(self): - self.lib.lammps_style_name(self.lmp, category.encode(), idx, sb, 100) - self._available_styles[category].append(sb.value.decode()) - return self._available_styles[category] - - # ------------------------------------------------------------------------- - - def has_id(self, category, name): - """Returns whether a given ID name is available in a given category - - This is a wrapper around the function :cpp:func:`lammps_has_id` - of the library interface. - - .. versionadded:: 9Oct2020 - - :param category: name of category - :type category: string - :param name: name of the ID - :type name: string - - :return: true if ID is available in given category - :rtype: bool - """ - return self.lib.lammps_has_id(self.lmp, category.encode(), name.encode()) != 0 - - # ------------------------------------------------------------------------- - - def available_ids(self, category): - """Returns a list of IDs available for a given category - - This is a wrapper around the functions :cpp:func:`lammps_id_count()` - and :cpp:func:`lammps_id_name()` of the library interface. - - .. versionadded:: 9Oct2020 - - :param category: name of category - :type category: string - - :return: list of id names in given category - :rtype: list - """ - - categories = ['compute','dump','fix','group','molecule','region','variable'] - available_ids = [] - if category in categories: - num = self.lib.lammps_id_count(self.lmp, category.encode()) - sb = create_string_buffer(100) - for idx in range(num): - self.lib.lammps_id_name(self.lmp, category.encode(), idx, sb, 100) - available_ids.append(sb.value.decode()) - return available_ids - - # ------------------------------------------------------------------------- - - def available_plugins(self, category): - """Returns a list of plugins available for a given category - - This is a wrapper around the functions :cpp:func:`lammps_plugin_count()` - and :cpp:func:`lammps_plugin_name()` of the library interface. - - .. versionadded:: 10Mar2021 - - :return: list of style/name pairs of loaded plugins - :rtype: list - """ - - available_plugins = [] - num = self.lib.lammps_plugin_count(self.lmp) - sty = create_string_buffer(100) - nam = create_string_buffer(100) - for idx in range(num): - self.lib.lammps_plugin_name(idx, sty, nam, 100) - available_plugins.append([sty.value.decode(), nam.value.decode()]) - return available_plugins - - # ------------------------------------------------------------------------- - - def set_fix_external_callback(self, fix_id, callback, caller=None): - """Set the callback function for a fix external instance with a given fix ID. - - Optionally also set a reference to the calling object. - - This is a wrapper around the :cpp:func:`lammps_set_fix_external_callback` function - of the C-library interface. However this is set up to call a Python function with - the following arguments. - - .. code-block: python - - def func(object, ntimestep, nlocal, tag, x, f): - - - object is the value of the "caller" argument - - ntimestep is the current timestep - - nlocal is the number of local atoms on the current MPI process - - tag is a 1d NumPy array of integers representing the atom IDs of the local atoms - - x is a 2d NumPy array of doubles of the coordinates of the local atoms - - f is a 2d NumPy array of doubles of the forces on the local atoms that will be added - - .. versionchanged:: 28Jul2021 - - :param fix_id: Fix-ID of a fix external instance - :type: string - :param callback: Python function that will be called from fix external - :type: function - :param caller: reference to some object passed to the callback function - :type: object, optional - """ - import numpy as np - - def callback_wrapper(caller, ntimestep, nlocal, tag_ptr, x_ptr, fext_ptr): - tag = self.numpy.iarray(self.c_tagint, tag_ptr, nlocal, 1) - x = self.numpy.darray(x_ptr, nlocal, 3) - f = self.numpy.darray(fext_ptr, nlocal, 3) - callback(caller, ntimestep, nlocal, tag, x, f) - - cFunc = self.FIX_EXTERNAL_CALLBACK_FUNC(callback_wrapper) - cCaller = caller - - self.callback[fix_id] = { 'function': cFunc, 'caller': caller } - with ExceptionCheck(self): - self.lib.lammps_set_fix_external_callback(self.lmp, fix_id.encode(), cFunc, cCaller) - - # ------------------------------------------------------------------------- - - def fix_external_get_force(self, fix_id): - """Get access to the array with per-atom forces of a fix external instance with a given fix ID. - - This is a wrapper around the :cpp:func:`lammps_fix_external_get_force` function - of the C-library interface. - - .. versionadded:: 28Jul2021 - - :param fix_id: Fix-ID of a fix external instance - :type: string - :return: requested data - :rtype: ctypes.POINTER(ctypes.POINTER(ctypes.double)) - """ - - with ExceptionCheck(self): - return self.lib.lammps_fix_external_get_force(self.lmp, fix_id.encode()) - - # ------------------------------------------------------------------------- - - def fix_external_set_energy_global(self, fix_id, eng): - """Set the global energy contribution for a fix external instance with the given ID. - - This is a wrapper around the :cpp:func:`lammps_fix_external_set_energy_global` function - of the C-library interface. - - .. versionadded:: 28Jul2021 - - :param fix_id: Fix-ID of a fix external instance - :type: string - :param eng: potential energy value to be added by fix external - :type: float - """ - - with ExceptionCheck(self): - return self.lib.lammps_fix_external_set_energy_global(self.lmp, fix_id.encode(), eng) - - # ------------------------------------------------------------------------- - - def fix_external_set_virial_global(self, fix_id, virial): - """Set the global virial contribution for a fix external instance with the given ID. - - This is a wrapper around the :cpp:func:`lammps_fix_external_set_virial_global` function - of the C-library interface. - - .. versionadded:: 28Jul2021 - - :param fix_id: Fix-ID of a fix external instance - :type: string - :param eng: list of 6 floating point numbers with the virial to be added by fix external - :type: float - """ - - cvirial = (6*c_double)(*virial) - with ExceptionCheck(self): - return self.lib.lammps_fix_external_set_virial_global(self.lmp, fix_id.encode(), cvirial) - - # ------------------------------------------------------------------------- - - def fix_external_set_energy_peratom(self, fix_id, eatom): - """Set the per-atom energy contribution for a fix external instance with the given ID. - - This is a wrapper around the :cpp:func:`lammps_fix_external_set_energy_peratom` function - of the C-library interface. - - .. versionadded:: 28Jul2021 - - :param fix_id: Fix-ID of a fix external instance - :type: string - :param eatom: list of potential energy values for local atoms to be added by fix external - :type: float - """ - - nlocal = self.extract_setting('nlocal') - if len(eatom) < nlocal: - raise Exception('per-atom energy list length must be at least nlocal') - ceatom = (nlocal*c_double)(*eatom) - with ExceptionCheck(self): - return self.lib.lammps_fix_external_set_energy_peratom(self.lmp, fix_id.encode(), ceatom) - - # ------------------------------------------------------------------------- - - def fix_external_set_virial_peratom(self, fix_id, vatom): - """Set the per-atom virial contribution for a fix external instance with the given ID. - - This is a wrapper around the :cpp:func:`lammps_fix_external_set_virial_peratom` function - of the C-library interface. - - .. versionadded:: 28Jul2021 - - :param fix_id: Fix-ID of a fix external instance - :type: string - :param vatom: list of natoms lists with 6 floating point numbers to be added by fix external - :type: float - """ - - # copy virial data to C compatible buffer - nlocal = self.extract_setting('nlocal') - if len(vatom) < nlocal: - raise Exception('per-atom virial first dimension must be at least nlocal') - if len(vatom[0]) != 6: - raise Exception('per-atom virial second dimension must be 6') - vbuf = (c_double * 6) - vptr = POINTER(c_double) - c_virial = (vptr * nlocal)() - for i in range(nlocal): - c_virial[i] = vbuf() - for j in range(6): - c_virial[i][j] = vatom[i][j] - - with ExceptionCheck(self): - return self.lib.lammps_fix_external_set_virial_peratom(self.lmp, fix_id.encode(), c_virial) - - # ------------------------------------------------------------------------- - def fix_external_set_vector_length(self, fix_id, length): - """Set the vector length for a global vector stored with fix external for analysis - - This is a wrapper around the :cpp:func:`lammps_fix_external_set_vector_length` function - of the C-library interface. - - .. versionadded:: 28Jul2021 - - :param fix_id: Fix-ID of a fix external instance - :type: string - :param length: length of the global vector - :type: int - """ - - with ExceptionCheck(self): - return self.lib.lammps_fix_external_set_vector_length(self.lmp, fix_id.encode(), length) - - # ------------------------------------------------------------------------- - def fix_external_set_vector(self, fix_id, idx, val): - """Store a global vector value for a fix external instance with the given ID. - - This is a wrapper around the :cpp:func:`lammps_fix_external_set_vector` function - of the C-library interface. - - .. versionadded:: 28Jul2021 - - :param fix_id: Fix-ID of a fix external instance - :type: string - :param idx: 1-based index of the value in the global vector - :type: int - :param val: value to be stored in the global vector - :type: float - """ - - with ExceptionCheck(self): - return self.lib.lammps_fix_external_set_vector(self.lmp, fix_id.encode(), idx, val) - - # ------------------------------------------------------------------------- - - def get_neighlist(self, idx): - """Returns an instance of :class:`NeighList` which wraps access to the neighbor list with the given index - - See :py:meth:`lammps.numpy.get_neighlist() ` if you want to use - NumPy arrays instead of ``c_int`` pointers. - - :param idx: index of neighbor list - :type idx: int - :return: an instance of :class:`NeighList` wrapping access to neighbor list data - :rtype: NeighList - """ - if idx < 0: - return None - return NeighList(self, idx) - - # ------------------------------------------------------------------------- - - def get_neighlist_size(self, idx): - """Return the number of elements in neighbor list with the given index - - :param idx: neighbor list index - :type idx: int - :return: number of elements in neighbor list with index idx - :rtype: int - """ - return self.lib.lammps_neighlist_num_elements(self.lmp, idx) - - # ------------------------------------------------------------------------- - - def get_neighlist_element_neighbors(self, idx, element): - """Return data of neighbor list entry - - :param element: neighbor list index - :type element: int - :param element: neighbor list element index - :type element: int - :return: tuple with atom local index, number of neighbors and array of neighbor local atom indices - :rtype: (int, int, POINTER(c_int)) - """ - c_iatom = c_int() - c_numneigh = c_int() - c_neighbors = POINTER(c_int)() - self.lib.lammps_neighlist_element_neighbors(self.lmp, idx, element, byref(c_iatom), byref(c_numneigh), byref(c_neighbors)) - return c_iatom.value, c_numneigh.value, c_neighbors - - # ------------------------------------------------------------------------- - - def find_pair_neighlist(self, style, exact=True, nsub=0, reqid=0): - """Find neighbor list index of pair style neighbor list - - Search for a neighbor list requested by a pair style instance that - matches "style". If exact is True, the pair style name must match - exactly. If exact is False, the pair style name is matched against - "style" as regular expression or sub-string. If the pair style is a - hybrid pair style, the style is instead matched against the hybrid - sub-styles. If the same pair style is used as sub-style multiple - types, you must set nsub to a value n > 0 which indicates the nth - instance of that sub-style to be used (same as for the pair_coeff - command). The default value of 0 will fail to match in that case. - - Once the pair style instance has been identified, it may have - requested multiple neighbor lists. Those are uniquely identified by - a request ID > 0 as set by the pair style. Otherwise the request - ID is 0. - - :param style: name of pair style that should be searched for - :type style: string - :param exact: controls whether style should match exactly or only must be contained in pair style name, defaults to True - :type exact: bool, optional - :param nsub: match nsub-th hybrid sub-style, defaults to 0 - :type nsub: int, optional - :param reqid: list request id, > 0 in case there are more than one, defaults to 0 - :type reqid: int, optional - :return: neighbor list index if found, otherwise -1 - :rtype: int - - """ - style = style.encode() - exact = int(exact) - idx = self.lib.lammps_find_pair_neighlist(self.lmp, style, exact, nsub, reqid) - return idx - - # ------------------------------------------------------------------------- - - def find_fix_neighlist(self, fixid, reqid=0): - """Find neighbor list index of fix neighbor list - - The fix instance requesting the neighbor list is uniquely identified - by the fix ID. In case the fix has requested multiple neighbor - lists, those are uniquely identified by a request ID > 0 as set by - the fix. Otherwise the request ID is 0 (the default). - - :param fixid: name of fix - :type fixid: string - :param reqid: id of neighbor list request, in case there are more than one request, defaults to 0 - :type reqid: int, optional - :return: neighbor list index if found, otherwise -1 - :rtype: int - - """ - fixid = fixid.encode() - idx = self.lib.lammps_find_fix_neighlist(self.lmp, fixid, reqid) - return idx - - # ------------------------------------------------------------------------- - - def find_compute_neighlist(self, computeid, reqid=0): - """Find neighbor list index of compute neighbor list - - The compute instance requesting the neighbor list is uniquely - identified by the compute ID. In case the compute has requested - multiple neighbor lists, those are uniquely identified by a request - ID > 0 as set by the compute. Otherwise the request ID is 0 (the - default). - - :param computeid: name of compute - :type computeid: string - :param reqid: index of neighbor list request, in case there are more than one request, defaults to 0 - :type reqid: int, optional - :return: neighbor list index if found, otherwise -1 - :rtype: int - - """ - computeid = computeid.encode() - idx = self.lib.lammps_find_compute_neighlist(self.lmp, computeid, reqid) - return idx diff --git a/python/lammps/data.py b/python/lammps/data.py deleted file mode 100644 index 731a8c514a..0000000000 --- a/python/lammps/data.py +++ /dev/null @@ -1,92 +0,0 @@ -# ---------------------------------------------------------------------- -# LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator -# https://www.lammps.org/ Sandia National Laboratories -# Steve Plimpton, sjplimp@sandia.gov -# -# Copyright (2003) Sandia Corporation. Under the terms of Contract -# DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains -# certain rights in this software. This software is distributed under -# the GNU General Public License. -# -# See the README file in the top-level LAMMPS directory. -# ------------------------------------------------------------------------- - -################################################################################ -# LAMMPS data structures -# Written by Richard Berger -################################################################################ - -class NeighList(object): - """This is a wrapper class that exposes the contents of a neighbor list. - - It can be used like a regular Python list. Each element is a tuple of: - - * the atom local index - * its number of neighbors - * and a pointer to an c_int array containing local atom indices of its - neighbors - - Internally it uses the lower-level LAMMPS C-library interface. - - :param lmp: reference to instance of :py:class:`lammps` - :type lmp: lammps - :param idx: neighbor list index - :type idx: int - """ - def __init__(self, lmp, idx): - self.lmp = lmp - self.idx = idx - - def __str__(self): - return "Neighbor List ({} atoms)".format(self.size) - - def __repr__(self): - return self.__str__() - - @property - def size(self): - """ - :return: number of elements in neighbor list - """ - return self.lmp.get_neighlist_size(self.idx) - - def get(self, element): - """ - Access a specific neighbor list entry. "element" must be a number from 0 to the size-1 of the list - - :return: tuple with atom local index, number of neighbors and ctypes pointer to neighbor's local atom indices - :rtype: (int, int, ctypes.POINTER(c_int)) - """ - iatom, numneigh, neighbors = self.lmp.get_neighlist_element_neighbors(self.idx, element) - return iatom, numneigh, neighbors - - # the methods below implement the iterator interface, so NeighList can be used like a regular Python list - - def __getitem__(self, element): - return self.get(element) - - def __len__(self): - return self.size - - def __iter__(self): - inum = self.size - - for ii in range(inum): - yield self.get(ii) - - def find(self, iatom): - """ - Find the neighbor list for a specific (local) atom iatom. - If there is no list for iatom, (-1, None) is returned. - - :return: tuple with number of neighbors and ctypes pointer to neighbor's local atom indices - :rtype: (int, ctypes.POINTER(c_int)) - """ - - inum = self.size - for ii in range(inum): - idx, numneigh, neighbors = self.get(ii) - if idx == iatom: - return numneigh, neighbors - - return -1, None diff --git a/python/lammps/formats.py b/python/lammps/formats.py deleted file mode 100644 index b7c267466f..0000000000 --- a/python/lammps/formats.py +++ /dev/null @@ -1,227 +0,0 @@ -# ---------------------------------------------------------------------- -# LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator -# https://www.lammps.org/ Sandia National Laboratories -# Steve Plimpton, sjplimp@sandia.gov -# -# Copyright (2003) Sandia Corporation. Under the terms of Contract -# DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains -# certain rights in this software. This software is distributed under -# the GNU General Public License. -# -# See the README file in the top-level LAMMPS directory. -# ------------------------------------------------------------------------- - -################################################################################ -# LAMMPS output formats -# Written by Richard Berger -# and Axel Kohlmeyer -################################################################################ - -import re - -has_yaml = False -try: - import yaml - has_yaml = True - try: - from yaml import CSafeLoader as Loader - except ImportError: - from yaml import SafeLoader as Loader -except ImportError: - # ignore here, raise an exception when trying to parse yaml instead - pass - -class LogFile: - """Reads LAMMPS log files and extracts the thermo information - - It supports the line, multi, and yaml thermo output styles. - - :param filename: path to log file - :type filename: str - - :ivar runs: List of LAMMPS runs in log file. Each run is a dictionary with - thermo fields as keys, storing the values over time - :ivar errors: List of error lines in log file - """ - - STYLE_DEFAULT = 0 - STYLE_MULTI = 1 - STYLE_YAML = 2 - - def __init__(self, filename): - alpha = re.compile(r'[a-df-zA-DF-Z]') # except e or E for floating-point numbers - kvpairs = re.compile(r'([a-zA-Z_0-9]+)\s+=\s*([0-9\.eE\-]+)') - style = LogFile.STYLE_DEFAULT - yamllog = "" - self.runs = [] - self.errors = [] - with open(filename, 'rt') as f: - in_thermo = False - in_data_section = False - for line in f: - if "ERROR" in line or "exited on signal" in line: - self.errors.append(line) - - elif re.match(r'^ *Step ', line): - in_thermo = True - in_data_section = True - keys = line.split() - current_run = {} - for k in keys: - current_run[k] = [] - - elif re.match(r'^(keywords:.*$|data:$|---$| - \[.*\]$)', line): - if not has_yaml: - raise Exception('Cannot process YAML format logs without the PyYAML Python module') - style = LogFile.STYLE_YAML - yamllog += line; - current_run = {} - - elif re.match(r'^\.\.\.$', line): - thermo = yaml.load(yamllog, Loader=Loader) - for k in thermo['keywords']: - current_run[k] = [] - for step in thermo['data']: - icol = 0 - for k in thermo['keywords']: - current_run[k].append(step[icol]) - icol += 1 - self.runs.append(current_run) - yamllog = "" - - elif re.match(r'^------* Step ', line): - if not in_thermo: - current_run = {'Step': [], 'CPU': []} - in_thermo = True - in_data_section = True - style = LogFile.STYLE_MULTI - str_step, str_cpu = line.strip('-\n').split('-----') - step = float(str_step.split()[1]) - cpu = float(str_cpu.split('=')[1].split()[0]) - current_run["Step"].append(step) - current_run["CPU"].append(cpu) - - elif line.startswith('Loop time of'): - in_thermo = False - if style != LogFile.STYLE_YAML: - self.runs.append(current_run) - - elif in_thermo and in_data_section: - if style == LogFile.STYLE_DEFAULT: - if alpha.search(line): - continue - for k, v in zip(keys, map(float, line.split())): - current_run[k].append(v) - - elif style == LogFile.STYLE_MULTI: - if '=' not in line: - in_data_section = False - continue - for k,v in kvpairs.findall(line): - if k not in current_run: - current_run[k] = [float(v)] - else: - current_run[k].append(float(v)) - -class AvgChunkFile: - """Reads files generated by fix ave/chunk - - :param filename: path to ave/chunk file - :type filename: str - - :ivar timesteps: List of timesteps stored in file - :ivar total_count: total count over time - :ivar chunks: List of chunks. Each chunk is a dictionary containing its ID, the coordinates, and the averaged quantities - """ - def __init__(self, filename): - with open(filename, 'rt') as f: - timestep = None - chunks_read = 0 - - self.timesteps = [] - self.total_count = [] - self.chunks = [] - - for lineno, line in enumerate(f): - if lineno == 0: - if not line.startswith("# Chunk-averaged data for fix"): - raise Exception("Chunk data reader only supports default avg/chunk headers!") - parts = line.split() - self.fix_name = parts[5] - self.group_name = parts[8] - continue - elif lineno == 1: - if not line.startswith("# Timestep Number-of-chunks Total-count"): - raise Exception("Chunk data reader only supports default avg/chunk headers!") - continue - elif lineno == 2: - if not line.startswith("#"): - raise Exception("Chunk data reader only supports default avg/chunk headers!") - columns = line.split()[1:] - ndim = line.count("Coord") - compress = 'OrigID' in line - if ndim > 0: - coord_start = columns.index("Coord1") - coord_end = columns.index("Coord%d" % ndim) - ncount_start = coord_end + 1 - data_start = ncount_start + 1 - else: - coord_start = None - coord_end = None - ncount_start = 2 - data_start = 3 - continue - - parts = line.split() - - if timestep is None: - timestep = int(parts[0]) - num_chunks = int(parts[1]) - total_count = float(parts[2]) - - self.timesteps.append(timestep) - self.total_count.append(total_count) - - for i in range(num_chunks): - self.chunks.append({ - 'coord' : [], - 'ncount' : [] - }) - elif chunks_read < num_chunks: - chunk = int(parts[0]) - ncount = float(parts[ncount_start]) - - if compress: - chunk_id = int(parts[1]) - else: - chunk_id = chunk - - current = self.chunks[chunk_id - 1] - current['id'] = chunk_id - current['ncount'].append(ncount) - - if ndim > 0: - coord = tuple(map(float, parts[coord_start:coord_end+1])) - current['coord'].append(coord) - - for i, data_column in list(enumerate(columns))[data_start:]: - value = float(parts[i]) - - if data_column in current: - current[data_column].append(value) - else: - current[data_column] = [value] - - chunks_read += 1 - assert chunk == chunks_read - else: - # do not support changing number of chunks - if not (num_chunks == int(parts[1])): - raise Exception("Currently, changing numbers of chunks are not supported.") - - timestep = int(parts[0]) - total_count = float(parts[2]) - chunks_read = 0 - - self.timesteps.append(timestep) - self.total_count.append(total_count) diff --git a/python/lammps/mliap/__init__.py b/python/lammps/mliap/__init__.py deleted file mode 100644 index 57fe97d803..0000000000 --- a/python/lammps/mliap/__init__.py +++ /dev/null @@ -1,20 +0,0 @@ - -# Check compatiblity of this build with the python shared library. -# If this fails, lammps will segfault because its library will -# try to improperly start up a new interpreter. -import sysconfig -import ctypes -library = sysconfig.get_config_vars('INSTSONAME')[0] -try: - pylib = ctypes.CDLL(library) -except OSError as e: - if pylib.endswith(".a"): - pylib.strip(".a") + ".so" - pylib = ctypes.CDLL(library) - else: - raise e -if not pylib.Py_IsInitialized(): - raise RuntimeError("This interpreter is not compatible with python-based mliap for LAMMPS.") -del sysconfig, ctypes, library, pylib - -from .loader import load_model, activate_mliappy diff --git a/python/lammps/mliap/loader.py b/python/lammps/mliap/loader.py deleted file mode 100644 index dff791bfc1..0000000000 --- a/python/lammps/mliap/loader.py +++ /dev/null @@ -1,52 +0,0 @@ -# ---------------------------------------------------------------------- -# LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator -# https://www.lammps.org/ Sandia National Laboratories -# Steve Plimpton, sjplimp@sandia.gov -# -# Copyright (2003) Sandia Corporation. Under the terms of Contract -# DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains -# certain rights in this software. This software is distributed under -# the GNU General Public License. -# -# See the README file in the top-level LAMMPS directory. -# ------------------------------------------------------------------------- - -# ---------------------------------------------------------------------- -# Contributing author: Nicholas Lubbers (LANL) -# ------------------------------------------------------------------------- - - -import sys -import importlib.util -import importlib.machinery - -def activate_mliappy(lmp): - try: - # Begin Importlib magic to find the embedded python module - # This is needed because the filename for liblammps does not - # match the spec for normal python modules, wherein - # file names match with PyInit function names. - # Also, python normally doesn't look for extensions besides '.so' - # We fix both of these problems by providing an explict - # path to the extension module 'mliap_model_python_couple' in - - path = lmp.lib._name - loader = importlib.machinery.ExtensionFileLoader('mliap_model_python_couple', path) - spec = importlib.util.spec_from_loader('mliap_model_python_couple', loader) - module = importlib.util.module_from_spec(spec) - sys.modules['mliap_model_python_couple'] = module - spec.loader.exec_module(module) - # End Importlib magic to find the embedded python module - - except Exception as ee: - raise ImportError("Could not load ML-IAP python coupling module.") from ee - -def load_model(model): - try: - import mliap_model_python_couple - except ImportError as ie: - raise ImportError("ML-IAP python module must be activated before loading\n" - "the pair style. Call lammps.mliap.activate_mliappy(lmp)." - ) from ie - mliap_model_python_couple.load_from_python(model) - diff --git a/python/lammps/mliap/pytorch.py b/python/lammps/mliap/pytorch.py deleted file mode 100644 index 9aa2da80f4..0000000000 --- a/python/lammps/mliap/pytorch.py +++ /dev/null @@ -1,326 +0,0 @@ -# ---------------------------------------------------------------------- -# LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator -# https://www.lammps.org/ Sandia National Laboratories -# Steve Plimpton, sjplimp@sandia.gov -# -# Copyright (2003) Sandia Corporation. Under the terms of Contract -# DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains -# certain rights in this software. This software is distributed under -# the GNU General Public License. -# -# See the README file in the top-level LAMMPS directory. -# ------------------------------------------------------------------------- - -# ---------------------------------------------------------------------- -# Contributing author: Nicholas Lubbers (LANL) -# ------------------------------------------------------------------------- - -import numpy as np -import torch - -def calc_n_params(model): - """ - Returns the sum of two decimal numbers in binary digits. - - Parameters: - model (torch.nn.Module): Network model that maps descriptors to a per atom attribute - - Returns: - n_params (int): Number of NN model parameters - """ - return sum(p.nelement() for p in model.parameters()) - -class TorchWrapper(torch.nn.Module): - """ - A class to wrap Modules to ensure lammps mliap compatability. - - ... - - Attributes - ---------- - model : torch.nn.Module - Network model that maps descriptors to a per atom attribute - - device : torch.nn.Module (None) - Accelerator device - - dtype : torch.dtype (torch.float64) - Dtype to use on device - - n_params : torch.nn.Module (None) - Number of NN model parameters - - n_descriptors : int - Max number of per atom descriptors - - n_elements : int - Max number of elements - - - Methods - ------- - forward(descriptors, elems): - Feeds descriptors to network model to produce per atom energies and forces. - """ - - def __init__(self, model, n_descriptors, n_elements, n_params=None, device=None, dtype=torch.float64): - """ - Constructs all the necessary attributes for the network module. - - Parameters - ---------- - model : torch.nn.Module - Network model that maps descriptors to a per atom attribute - - n_descriptors : int - Max number of per atom descriptors - - n_elements : int - Max number of elements - - n_params : torch.nn.Module (None) - Number of NN model parameters - - device : torch.nn.Module (None) - Accelerator device - - dtype : torch.dtype (torch.float64) - Dtype to use on device - """ - - super().__init__() - - self.model = model - self.device = device - self.dtype = dtype - - # Put model on device and convert to dtype - self.to(self.dtype) - self.to(self.device) - - if n_params is None: - n_params = calc_n_params(model) - - self.n_params = n_params - self.n_descriptors = n_descriptors - self.n_elements = n_elements - - def forward(self, elems, descriptors, beta, energy): - """ - Takes element types and descriptors calculated via lammps and - calculates the per atom energies and forces. - - Parameters - ---------- - elems : numpy.array - Per atom element types - - descriptors : numpy.array - Per atom descriptors - - beta : numpy.array - Expired beta array to be filled with new betas - - energy : numpy.array - Expired per atom energy array to be filled with new per atom energy - (Note: This is a pointer to the lammps per atom energies) - - - Returns - ------- - None - """ - - descriptors = torch.from_numpy(descriptors).to(dtype=self.dtype, device=self.device).requires_grad_(True) - elems = torch.from_numpy(elems).to(dtype=torch.long, device=self.device) - 1 - - with torch.autograd.enable_grad(): - - energy_nn = self.model(descriptors, elems) - if energy_nn.ndim > 1: - energy_nn = energy_nn.flatten() - - beta_nn = torch.autograd.grad(energy_nn.sum(), descriptors)[0] - - beta[:] = beta_nn.detach().cpu().numpy().astype(np.float64) - energy[:] = energy_nn.detach().cpu().numpy().astype(np.float64) - - -class IgnoreElems(torch.nn.Module): - """ - A class to represent a NN model agnostic of element typing. - - ... - - Attributes - ---------- - subnet : torch.nn.Module - Network model that maps descriptors to a per atom attribute - - Methods - ------- - forward(descriptors, elems): - Feeds descriptors to network model - """ - - def __init__(self, subnet): - """ - Constructs all the necessary attributes for the network module. - - Parameters - ---------- - subnet : torch.nn.Module - Network model that maps descriptors to a per atom attribute - """ - - super().__init__() - self.subnet = subnet - - def forward(self, descriptors, elems): - """ - Feeds descriptors to network model - - Parameters - ---------- - descriptors : torch.tensor - Per atom descriptors - - elems : torch.tensor - Per atom element types - - Returns - ------- - self.subnet(descriptors) : torch.tensor - Per atom attribute computed by the network model - """ - - return self.subnet(descriptors) - - -class UnpackElems(torch.nn.Module): - """ - A class to represent a NN model pseudo-agnostic of element typing for - systems with multiple element typings. - - ... - - Attributes - ---------- - subnet : torch.nn.Module - Network model that maps descriptors to a per atom attribute - - n_types : int - Number of atom types used in training the NN model. - - Methods - ------- - forward(descriptors, elems): - Feeds descriptors to network model after adding zeros into - descriptor columns relating to different atom types - """ - - def __init__(self, subnet, n_types): - """ - Constructs all the necessary attributes for the network module. - - Parameters - ---------- - subnet : torch.nn.Module - Network model that maps descriptors to a per atom attribute. - - n_types : int - Number of atom types used in training the NN model. - """ - super().__init__() - self.subnet = subnet - self.n_types = n_types - - def forward(self, descriptors, elems): - """ - Feeds descriptors to network model after adding zeros into - descriptor columns relating to different atom types - - Parameters - ---------- - descriptors : torch.tensor - Per atom descriptors - - elems : torch.tensor - Per atom element types - - Returns - ------- - self.subnet(descriptors) : torch.tensor - Per atom attribute computed by the network model - """ - - unpacked_descriptors = torch.zeros(elems.shape[0], self.n_types, descriptors.shape[1], dtype=torch.float64) - for i, ind in enumerate(elems): - unpacked_descriptors[i, ind, :] = descriptors[i] - return self.subnet(torch.reshape(unpacked_descriptors, (elems.shape[0], -1)), elems) - - -class ElemwiseModels(torch.nn.Module): - """ - A class to represent a NN model dependent on element typing. - - ... - - Attributes - ---------- - subnets : list of torch.nn.Modules - Per element type network models that maps per element type - descriptors to a per atom attribute. - - n_types : int - Number of atom types used in training the NN model. - - Methods - ------- - forward(descriptors, elems): - Feeds descriptors to network model after adding zeros into - descriptor columns relating to different atom types - """ - - def __init__(self, subnets, n_types): - """ - Constructs all the necessary attributes for the network module. - - Parameters - ---------- - subnets : list of torch.nn.Modules - Per element type network models that maps per element - type descriptors to a per atom attribute. - - n_types : int - Number of atom types used in training the NN model. - """ - - super().__init__() - self.subnets = subnets - self.n_types = n_types - - def forward(self, descriptors, elems): - """ - Feeds descriptors to network model after adding zeros into - descriptor columns relating to different atom types - - Parameters - ---------- - descriptors : torch.tensor - Per atom descriptors - - elems : torch.tensor - Per atom element types - - Returns - ------- - self.subnets(descriptors) : torch.tensor - Per atom attribute computed by the network model - """ - - per_atom_attributes = torch.zeros(elems.size[0]) - given_elems, elem_indices = torch.unique(elems, return_inverse=True) - for i, elem in enumerate(given_elems): - per_atom_attribute[elem_indices == i] = self.subnets[elem](descriptors[elem_indices == i]) - return per_atom_attributes diff --git a/python/lammps/numpy_wrapper.py b/python/lammps/numpy_wrapper.py deleted file mode 100644 index ce0cb35e47..0000000000 --- a/python/lammps/numpy_wrapper.py +++ /dev/null @@ -1,483 +0,0 @@ -# ---------------------------------------------------------------------- -# LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator -# https://www.lammps.org/ Sandia National Laboratories -# Steve Plimpton, sjplimp@sandia.gov -# -# Copyright (2003) Sandia Corporation. Under the terms of Contract -# DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains -# certain rights in this software. This software is distributed under -# the GNU General Public License. -# -# See the README file in the top-level LAMMPS directory. -# ------------------------------------------------------------------------- - -################################################################################ -# NumPy additions -# Written by Richard Berger -################################################################################ - -import warnings -from ctypes import POINTER, c_void_p, c_char_p, c_double, c_int, c_int32, c_int64, cast - - -from .constants import * # lgtm [py/polluting-import] -from .data import NeighList - - -class numpy_wrapper: - """lammps API NumPy Wrapper - - This is a wrapper class that provides additional methods on top of an - existing :py:class:`lammps` instance. The methods transform raw ctypes - pointers into NumPy arrays, which give direct access to the - original data while protecting against out-of-bounds accesses. - - There is no need to explicitly instantiate this class. Each instance - of :py:class:`lammps` has a :py:attr:`numpy ` property - that returns an instance. - - :param lmp: instance of the :py:class:`lammps` class - :type lmp: lammps - """ - def __init__(self, lmp): - self.lmp = lmp - - # ------------------------------------------------------------------------- - - def _ctype_to_numpy_int(self, ctype_int): - import numpy as np - if ctype_int == c_int32: - return np.int32 - elif ctype_int == c_int64: - return np.int64 - return np.intc - - # ------------------------------------------------------------------------- - - def extract_atom(self, name, dtype=LAMMPS_AUTODETECT, nelem=LAMMPS_AUTODETECT, dim=LAMMPS_AUTODETECT): - """Retrieve per-atom properties from LAMMPS as NumPy arrays - - This is a wrapper around the :py:meth:`lammps.extract_atom()` method. - It behaves the same as the original method, but returns NumPy arrays - instead of ``ctypes`` pointers. - - .. note:: - - While the returned arrays of per-atom data are dimensioned - for the range [0:nmax] - as is the underlying storage - - the data is usually only valid for the range of [0:nlocal], - unless the property of interest is also updated for ghost - atoms. In some cases, this depends on a LAMMPS setting, see - for example :doc:`comm_modify vel yes `. - - :param name: name of the property - :type name: string - :param dtype: type of the returned data (see :ref:`py_datatype_constants`) - :type dtype: int, optional - :param nelem: number of elements in array - :type nelem: int, optional - :param dim: dimension of each element - :type dim: int, optional - :return: requested data as NumPy array with direct access to C data or None - :rtype: numpy.array or NoneType - """ - if dtype == LAMMPS_AUTODETECT: - dtype = self.lmp.extract_atom_datatype(name) - - if nelem == LAMMPS_AUTODETECT: - if name == "mass": - nelem = self.lmp.extract_global("ntypes") + 1 - else: - nelem = self.lmp.extract_global("nlocal") - if dim == LAMMPS_AUTODETECT: - if dtype in (LAMMPS_INT_2D, LAMMPS_DOUBLE_2D, LAMMPS_INT64_2D): - # TODO add other fields - if name in ("x", "v", "f", "x0","omega", "angmom", "torque", "csforce", "vforce", "vest"): - dim = 3 - elif name == "smd_data_9": - dim = 9 - elif name == "smd_stress": - dim = 6 - else: - dim = 2 - else: - dim = 1 - - raw_ptr = self.lmp.extract_atom(name, dtype) - - if dtype in (LAMMPS_DOUBLE, LAMMPS_DOUBLE_2D): - return self.darray(raw_ptr, nelem, dim) - elif dtype in (LAMMPS_INT, LAMMPS_INT_2D): - return self.iarray(c_int32, raw_ptr, nelem, dim) - elif dtype in (LAMMPS_INT64, LAMMPS_INT64_2D): - return self.iarray(c_int64, raw_ptr, nelem, dim) - return raw_ptr - - # ------------------------------------------------------------------------- - - def extract_atom_iarray(self, name, nelem, dim=1): - warnings.warn("deprecated, use extract_atom instead", DeprecationWarning) - - if name in ['id', 'molecule']: - c_int_type = self.lmp.c_tagint - elif name in ['image']: - c_int_type = self.lmp.c_imageint - else: - c_int_type = c_int - - if dim == 1: - raw_ptr = self.lmp.extract_atom(name, LAMMPS_INT) - else: - raw_ptr = self.lmp.extract_atom(name, LAMMPS_INT_2D) - - return self.iarray(c_int_type, raw_ptr, nelem, dim) - - # ------------------------------------------------------------------------- - - def extract_atom_darray(self, name, nelem, dim=1): - warnings.warn("deprecated, use extract_atom instead", DeprecationWarning) - - if dim == 1: - raw_ptr = self.lmp.extract_atom(name, LAMMPS_DOUBLE) - else: - raw_ptr = self.lmp.extract_atom(name, LAMMPS_DOUBLE_2D) - - return self.darray(raw_ptr, nelem, dim) - - # ------------------------------------------------------------------------- - - def extract_compute(self, cid, cstyle, ctype): - """Retrieve data from a LAMMPS compute - - This is a wrapper around the - :py:meth:`lammps.extract_compute() ` method. - It behaves the same as the original method, but returns NumPy arrays - instead of ``ctypes`` pointers. - - :param cid: compute ID - :type cid: string - :param cstyle: style of the data retrieve (global, atom, or local), see :ref:`py_style_constants` - :type cstyle: int - :param ctype: type of the returned data (scalar, vector, or array), see :ref:`py_type_constants` - :type ctype: int - :return: requested data either as float, as NumPy array with direct access to C data, or None - :rtype: float, numpy.array, or NoneType - """ - value = self.lmp.extract_compute(cid, cstyle, ctype) - - if cstyle == LMP_STYLE_GLOBAL: - if ctype == LMP_TYPE_VECTOR: - nrows = self.lmp.extract_compute(cid, cstyle, LMP_SIZE_VECTOR) - return self.darray(value, nrows) - elif ctype == LMP_TYPE_ARRAY: - nrows = self.lmp.extract_compute(cid, cstyle, LMP_SIZE_ROWS) - ncols = self.lmp.extract_compute(cid, cstyle, LMP_SIZE_COLS) - return self.darray(value, nrows, ncols) - elif cstyle == LMP_STYLE_LOCAL: - nrows = self.lmp.extract_compute(cid, cstyle, LMP_SIZE_ROWS) - ncols = self.lmp.extract_compute(cid, cstyle, LMP_SIZE_COLS) - if ncols == 0: - return self.darray(value, nrows) - else: - return self.darray(value, nrows, ncols) - elif cstyle == LMP_STYLE_ATOM: - if ctype == LMP_TYPE_VECTOR: - nlocal = self.lmp.extract_global("nlocal") - return self.darray(value, nlocal) - elif ctype == LMP_TYPE_ARRAY: - nlocal = self.lmp.extract_global("nlocal") - ncols = self.lmp.extract_compute(cid, cstyle, LMP_SIZE_COLS) - return self.darray(value, nlocal, ncols) - return value - - # ------------------------------------------------------------------------- - - def extract_fix(self, fid, fstyle, ftype, nrow=0, ncol=0): - """Retrieve data from a LAMMPS fix - - This is a wrapper around the :py:meth:`lammps.extract_fix() ` method. - It behaves the same as the original method, but returns NumPy arrays - instead of ``ctypes`` pointers. - - :param fid: fix ID - :type fid: string - :param fstyle: style of the data retrieve (global, atom, or local), see :ref:`py_style_constants` - :type fstyle: int - :param ftype: type or size of the returned data (scalar, vector, or array), see :ref:`py_type_constants` - :type ftype: int - :param nrow: index of global vector element or row index of global array element - :type nrow: int - :param ncol: column index of global array element - :type ncol: int - :return: requested data - :rtype: integer or double value, pointer to 1d or 2d double array or None - - """ - value = self.lmp.extract_fix(fid, fstyle, ftype, nrow, ncol) - if fstyle == LMP_STYLE_ATOM: - if ftype == LMP_TYPE_VECTOR: - nlocal = self.lmp.extract_global("nlocal") - return self.darray(value, nlocal) - elif ftype == LMP_TYPE_ARRAY: - nlocal = self.lmp.extract_global("nlocal") - ncols = self.lmp.extract_fix(fid, fstyle, LMP_SIZE_COLS, 0, 0) - return self.darray(value, nlocal, ncols) - elif fstyle == LMP_STYLE_LOCAL: - if ftype == LMP_TYPE_VECTOR: - nrows = self.lmp.extract_fix(fid, fstyle, LMP_SIZE_ROWS, 0, 0) - return self.darray(value, nrows) - elif ftype == LMP_TYPE_ARRAY: - nrows = self.lmp.extract_fix(fid, fstyle, LMP_SIZE_ROWS, 0, 0) - ncols = self.lmp.extract_fix(fid, fstyle, LMP_SIZE_COLS, 0, 0) - return self.darray(value, nrows, ncols) - return value - - # ------------------------------------------------------------------------- - - def extract_variable(self, name, group=None, vartype=LMP_VAR_EQUAL): - """ Evaluate a LAMMPS variable and return its data - - This function is a wrapper around the function - :py:meth:`lammps.extract_variable() ` - method. It behaves the same as the original method, but returns NumPy arrays - instead of ``ctypes`` pointers. - - :param name: name of the variable to execute - :type name: string - :param group: name of group for atom-style variable (ignored for equal-style variables) - :type group: string - :param vartype: type of variable, see :ref:`py_vartype_constants` - :type vartype: int - :return: the requested data or None - :rtype: c_double, numpy.array, or NoneType - """ - import numpy as np - value = self.lmp.extract_variable(name, group, vartype) - if vartype == LMP_VAR_ATOM: - return np.ctypeslib.as_array(value) - return value - - # ------------------------------------------------------------------------- - - def gather_bonds(self): - """Retrieve global list of bonds as NumPy array - - This is a wrapper around :py:meth:`lammps.gather_bonds() ` - It behaves the same as the original method, but returns a NumPy array instead - of a ``ctypes`` list. - - .. versionadded:: 28Jul2021 - - :return: the requested data as a 2d-integer numpy array - :rtype: numpy.array(nbonds,3) - """ - import numpy as np - nbonds, value = self.lmp.gather_bonds() - return np.ctypeslib.as_array(value).reshape(nbonds,3) - - # ------------------------------------------------------------------------- - - def fix_external_get_force(self, fix_id): - """Get access to the array with per-atom forces of a fix external instance with a given fix ID. - - This function is a wrapper around the - :py:meth:`lammps.fix_external_get_force() ` - method. It behaves the same as the original method, but returns a NumPy array instead - of a ``ctypes`` pointer. - - .. versionchanged:: 28Jul2021 - - :param fix_id: Fix-ID of a fix external instance - :type: string - :return: requested data - :rtype: numpy.array - """ - import numpy as np - nlocal = self.lmp.extract_setting('nlocal') - value = self.lmp.fix_external_get_force(fix_id) - return self.darray(value,nlocal,3) - - # ------------------------------------------------------------------------- - - def fix_external_set_energy_peratom(self, fix_id, eatom): - """Set the per-atom energy contribution for a fix external instance with the given ID. - - This function is an alternative to - :py:meth:`lammps.fix_external_set_energy_peratom() ` - method. It behaves the same as the original method, but accepts a NumPy array - instead of a list as argument. - - .. versionadded:: 28Jul2021 - - :param fix_id: Fix-ID of a fix external instance - :type: string - :param eatom: per-atom potential energy - :type: numpy.array - """ - import numpy as np - nlocal = self.lmp.extract_setting('nlocal') - if len(eatom) < nlocal: - raise Exception('per-atom energy dimension must be at least nlocal') - - c_double_p = POINTER(c_double) - value = eatom.astype(np.double) - return self.lmp.lib.lammps_fix_external_set_energy_peratom(self.lmp.lmp, fix_id.encode(), - value.ctypes.data_as(c_double_p)) - - # ------------------------------------------------------------------------- - - def fix_external_set_virial_peratom(self, fix_id, vatom): - """Set the per-atom virial contribution for a fix external instance with the given ID. - - This function is an alternative to - :py:meth:`lammps.fix_external_set_virial_peratom() ` - method. It behaves the same as the original method, but accepts a NumPy array - instead of a list as argument. - - .. versionadded:: 28Jul2021 - - :param fix_id: Fix-ID of a fix external instance - :type: string - :param eatom: per-atom potential energy - :type: numpy.array - """ - import numpy as np - nlocal = self.lmp.extract_setting('nlocal') - if len(vatom) < nlocal: - raise Exception('per-atom virial first dimension must be at least nlocal') - if len(vatom[0]) != 6: - raise Exception('per-atom virial second dimension must be 6') - - c_double_pp = np.ctypeslib.ndpointer(dtype=np.uintp, ndim=1, flags='C') - - # recast numpy array to be compatible with library interface - value = (vatom.__array_interface__['data'][0] - + np.arange(vatom.shape[0])*vatom.strides[0]).astype(np.uintp) - - # change prototype to our custom type - self.lmp.lib.lammps_fix_external_set_virial_peratom.argtypes = [ c_void_p, c_char_p, c_double_pp ] - - self.lmp.lib.lammps_fix_external_set_virial_peratom(self.lmp.lmp, fix_id.encode(), value) - - # ------------------------------------------------------------------------- - - def get_neighlist(self, idx): - """Returns an instance of :class:`NumPyNeighList` which wraps access to the neighbor list with the given index - - :param idx: index of neighbor list - :type idx: int - :return: an instance of :class:`NumPyNeighList` wrapping access to neighbor list data - :rtype: NumPyNeighList - """ - if idx < 0: - return None - return NumPyNeighList(self.lmp, idx) - - # ------------------------------------------------------------------------- - - def get_neighlist_element_neighbors(self, idx, element): - """Return data of neighbor list entry - - This function is a wrapper around the function - :py:meth:`lammps.get_neighlist_element_neighbors() ` - method. It behaves the same as the original method, but returns a NumPy array containing the neighbors - instead of a ``ctypes`` pointer. - - :param element: neighbor list index - :type element: int - :param element: neighbor list element index - :type element: int - :return: tuple with atom local index and numpy array of neighbor local atom indices - :rtype: (int, numpy.array) - """ - iatom, numneigh, c_neighbors = self.lmp.get_neighlist_element_neighbors(idx, element) - neighbors = self.iarray(c_int, c_neighbors, numneigh, 1) - return iatom, neighbors - - # ------------------------------------------------------------------------- - - def iarray(self, c_int_type, raw_ptr, nelem, dim=1): - if raw_ptr is None: - return None - - import numpy as np - np_int_type = self._ctype_to_numpy_int(c_int_type) - - if dim == 1: - ptr = cast(raw_ptr, POINTER(c_int_type * nelem)) - else: - ptr = cast(raw_ptr[0], POINTER(c_int_type * nelem * dim)) - - a = np.frombuffer(ptr.contents, dtype=np_int_type) - - if dim > 1: - a.shape = (nelem, dim) - else: - a.shape = (nelem) - return a - - # ------------------------------------------------------------------------- - - def darray(self, raw_ptr, nelem, dim=1): - if raw_ptr is None: - return None - - import numpy as np - - if dim == 1: - ptr = cast(raw_ptr, POINTER(c_double * nelem)) - else: - ptr = cast(raw_ptr[0], POINTER(c_double * nelem * dim)) - - a = np.frombuffer(ptr.contents) - - if dim > 1: - a.shape = (nelem, dim) - else: - a.shape = (nelem) - return a - -# ------------------------------------------------------------------------- - -class NumPyNeighList(NeighList): - """This is a wrapper class that exposes the contents of a neighbor list. - - It can be used like a regular Python list. Each element is a tuple of: - - * the atom local index - * a NumPy array containing the local atom indices of its neighbors - - Internally it uses the lower-level LAMMPS C-library interface. - - :param lmp: reference to instance of :py:class:`lammps` - :type lmp: lammps - :param idx: neighbor list index - :type idx: int - """ - def __init__(self, lmp, idx): - super(NumPyNeighList, self).__init__(lmp, idx) - - def get(self, element): - """ - Access a specific neighbor list entry. "element" must be a number from 0 to the size-1 of the list - - :return: tuple with atom local index, numpy array of neighbor local atom indices - :rtype: (int, numpy.array) - """ - iatom, neighbors = self.lmp.numpy.get_neighlist_element_neighbors(self.idx, element) - return iatom, neighbors - - def find(self, iatom): - """ - Find the neighbor list for a specific (local) atom iatom. - If there is no list for iatom, None is returned. - - :return: numpy array of neighbor local atom indices - :rtype: numpy.array or None - """ - inum = self.size - for ii in range(inum): - idx, neighbors = self.get(ii) - if idx == iatom: - return neighbors - return None diff --git a/python/lammps/pylammps.py b/python/lammps/pylammps.py deleted file mode 100644 index 1fe1f2452b..0000000000 --- a/python/lammps/pylammps.py +++ /dev/null @@ -1,990 +0,0 @@ -# ---------------------------------------------------------------------- -# LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator -# https://www.lammps.org/ Sandia National Laboratories -# Steve Plimpton, sjplimp@sandia.gov -# -# Copyright (2003) Sandia Corporation. Under the terms of Contract -# DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains -# certain rights in this software. This software is distributed under -# the GNU General Public License. -# -# See the README file in the top-level LAMMPS directory. -# ------------------------------------------------------------------------- - -################################################################################ -# Alternative Python Wrapper -# Written by Richard Berger -################################################################################ - -# for python2/3 compatibility - -from __future__ import print_function - -import io -import os -import re -import sys -import tempfile -from collections import namedtuple - -from .core import lammps - -# ------------------------------------------------------------------------- - -class OutputCapture(object): - """ Utility class to capture LAMMPS library output """ - def __init__(self): - self.stdout_fd = 1 - self.captured_output = "" - - def __enter__(self): - self.tmpfile = tempfile.TemporaryFile(mode='w+b') - - sys.stdout.flush() - - # make copy of original stdout - self.stdout_orig = os.dup(self.stdout_fd) - - # replace stdout and redirect to temp file - os.dup2(self.tmpfile.fileno(), self.stdout_fd) - return self - - def __exit__(self, exc_type, exc_value, traceback): - os.dup2(self.stdout_orig, self.stdout_fd) - os.close(self.stdout_orig) - self.tmpfile.close() - - @property - def output(self): - sys.stdout.flush() - self.tmpfile.flush() - self.tmpfile.seek(0, io.SEEK_SET) - self.captured_output = self.tmpfile.read().decode('utf-8') - return self.captured_output - -# ------------------------------------------------------------------------- - -class Variable(object): - def __init__(self, pylammps_instance, name, style, definition): - self._pylmp = pylammps_instance - self.name = name - self.style = style - self.definition = definition.split() - - @property - def value(self): - if self.style == 'atom': - return list(self._pylmp.lmp.extract_variable(self.name, "all", 1)) - else: - value = self._pylmp.lmp_print('"${%s}"' % self.name).strip() - try: - return float(value) - except ValueError: - return value - -# ------------------------------------------------------------------------- - -class AtomList(object): - """ - A dynamic list of atoms that returns either an :py:class:`Atom` or - :py:class:`Atom2D` instance for each atom. Instances are only allocated - when accessed. - - :ivar natoms: total number of atoms - :ivar dimensions: number of dimensions in system - """ - def __init__(self, pylammps_instance): - self._pylmp = pylammps_instance - self.natoms = self._pylmp.system.natoms - self.dimensions = self._pylmp.system.dimensions - self._loaded = {} - - def __getitem__(self, index): - """ - Return Atom with given local index - - :param index: Local index of atom - :type index: int - :rtype: Atom or Atom2D - """ - if index not in self._loaded: - if self.dimensions == 2: - atom = Atom2D(self._pylmp, index) - else: - atom = Atom(self._pylmp, index) - self._loaded[index] = atom - return self._loaded[index] - - def __len__(self): - return self.natoms - - -# ------------------------------------------------------------------------- - -class Atom(object): - """ - A wrapper class then represents a single atom inside of LAMMPS - - It provides access to properties of the atom and allows you to change some of them. - """ - def __init__(self, pylammps_instance, index): - self._pylmp = pylammps_instance - self.index = index - - def __dir__(self): - return [k for k in super().__dir__() if not k.startswith('_')] - - def get(self, name, index): - prop = self._pylmp.lmp.numpy.extract_atom(name) - if prop is not None: - return prop[index] - return None - - @property - def id(self): - """ - Return the atom ID - - :type: int - """ - return self.get("id", self.index) - - @property - def type(self): - """ - Return the atom type - - :type: int - """ - return self.get("type", self.index) - - @property - def mol(self): - """ - Return the atom molecule index - - :type: int - """ - return self.get("mol", self.index) - - @property - def mass(self): - """ - Return the atom mass - - :type: float - """ - return self.get("mass", self.index) - - @property - def radius(self): - """ - Return the particle radius - - :type: float - """ - return self.get("radius", self.index) - - @property - def position(self): - """ - :getter: Return position of atom - :setter: Set position of atom - :type: numpy.array (float, float, float) - """ - return self.get("x", self.index) - - @position.setter - def position(self, value): - current = self.position - current[:] = value - - @property - def velocity(self): - """ - :getter: Return velocity of atom - :setter: Set velocity of atom - :type: numpy.array (float, float, float) - """ - return self.get("v", self.index) - - @velocity.setter - def velocity(self, value): - current = self.velocity - current[:] = value - - @property - def force(self): - """ - Return the total force acting on the atom - - :type: numpy.array (float, float, float) - """ - return self.get("f", self.index) - - @force.setter - def force(self, value): - current = self.force - current[:] = value - - @property - def torque(self): - """ - Return the total torque acting on the atom - - :type: numpy.array (float, float, float) - """ - return self.get("torque", self.index) - - @force.setter - def torque(self, value): - current = self.torque - current[:] = value - - @property - def omega(self): - """ - Return the rotational velocity of the particle - - :type: numpy.array (float, float, float) - """ - return self.get("torque", self.index) - - @omega.setter - def omega(self, value): - current = self.torque - current[:] = value - - @property - def torque(self): - """ - Return the total torque acting on the particle - - :type: numpy.array (float, float, float) - """ - return self.get("torque", self.index) - - @torque.setter - def torque(self, value): - current = self.torque - current[:] = value - - @property - def angular_momentum(self): - """ - Return the angular momentum of the particle - - :type: numpy.array (float, float, float) - """ - return self.get("angmom", self.index) - - @angular_momentum.setter - def angular_momentum(self, value): - current = self.angular_momentum - current[:] = value - - @property - def charge(self): - """ - Return the atom charge - - :type: float - """ - return self.get("q", self.index) - -# ------------------------------------------------------------------------- - -class Atom2D(Atom): - """ - A wrapper class then represents a single 2D atom inside of LAMMPS - - Inherits all properties from the :py:class:`Atom` class, but returns 2D versions - of position, velocity, and force. - - It provides access to properties of the atom and allows you to change some of them. - """ - def __init__(self, pylammps_instance, index): - super(Atom2D, self).__init__(pylammps_instance, index) - - @property - def position(self): - """Access to coordinates of an atom - - :getter: Return position of atom - :setter: Set position of atom - :type: numpy.array (float, float) - """ - return super(Atom2D, self).position[0:2] - - @position.setter - def position(self, value): - current = self.position - current[:] = value - - @property - def velocity(self): - """Access to velocity of an atom - :getter: Return velocity of atom - :setter: Set velocity of atom - :type: numpy.array (float, float) - """ - return super(Atom2D, self).velocity[0:2] - - @velocity.setter - def velocity(self, value): - current = self.velocity - current[:] = value - - @property - def force(self): - """Access to force of an atom - :getter: Return force of atom - :setter: Set force of atom - :type: numpy.array (float, float) - """ - return super(Atom2D, self).force[0:2] - - @force.setter - def force(self, value): - current = self.force - current[:] = value - -# ------------------------------------------------------------------------- - -class variable_set: - def __init__(self, name, variable_dict): - self._name = name - array_pattern = re.compile(r"(?P.+)\[(?P[0-9]+)\]") - - for key, value in variable_dict.items(): - m = array_pattern.match(key) - if m: - g = m.groupdict() - varname = g['arr'] - idx = int(g['index']) - if varname not in self.__dict__: - self.__dict__[varname] = {} - self.__dict__[varname][idx] = value - else: - self.__dict__[key] = value - - def __str__(self): - return "{}({})".format(self._name, ','.join(["{}={}".format(k, self.__dict__[k]) for k in self.__dict__.keys() if not k.startswith('_')])) - - def __dir__(self): - return [k for k in self.__dict__.keys() if not k.startswith('_')] - - def __repr__(self): - return self.__str__() - -# ------------------------------------------------------------------------- - -def get_thermo_data(output): - """ traverse output of runs and extract thermo data columns """ - if isinstance(output, str): - lines = output.splitlines() - else: - lines = output - - runs = [] - columns = [] - in_run = False - current_run = {} - - for line in lines: - if line.startswith("Per MPI rank memory allocation"): - in_run = True - elif in_run and len(columns) == 0: - # first line after memory usage are column names - columns = line.split() - - current_run = {} - - for col in columns: - current_run[col] = [] - - elif line.startswith("Loop time of "): - in_run = False - columns = [] - thermo_data = variable_set('ThermoData', current_run) - r = {'thermo' : thermo_data } - runs.append(namedtuple('Run', list(r.keys()))(*list(r.values()))) - elif in_run and len(columns) > 0: - items = line.split() - # Convert thermo output and store it. - # It must have the same number of columns and - # all of them must be convertible to floats. - # Otherwise we ignore the line - if len(items) == len(columns): - try: - values = [float(x) for x in items] - for i, col in enumerate(columns): - current_run[col].append(values[i]) - except ValueError: - # cannot convert. must be a non-thermo output. ignore. - pass - - return runs - -# ------------------------------------------------------------------------- -# ------------------------------------------------------------------------- - -class PyLammps(object): - """ - This is a Python wrapper class around the lower-level - :py:class:`lammps` class, exposing a more Python-like, - object-oriented interface for prototyping system inside of IPython and - Jupyter notebooks. - - It either creates its own instance of :py:class:`lammps` or can be - initialized with an existing instance. The arguments are the same of the - lower-level interface. The original interface can still be accessed via - :py:attr:`PyLammps.lmp`. - - :param name: "machine" name of the shared LAMMPS library ("mpi" loads ``liblammps_mpi.so``, "" loads ``liblammps.so``) - :type name: string - :param cmdargs: list of command line arguments to be passed to the :cpp:func:`lammps_open` function. The executable name is automatically added. - :type cmdargs: list - :param ptr: pointer to a LAMMPS C++ class instance when called from an embedded Python interpreter. None means load symbols from shared library. - :type ptr: pointer - :param comm: MPI communicator (as provided by `mpi4py `_). ``None`` means use ``MPI_COMM_WORLD`` implicitly. - :type comm: MPI_Comm - :param verbose: print all LAMMPS output to stdout - :type verbose: bool - - :ivar lmp: instance of original LAMMPS Python interface - :vartype lmp: :py:class:`lammps` - - :ivar runs: list of completed runs, each storing the thermo output - :vartype run: list - """ - - def __init__(self, name="", cmdargs=None, ptr=None, comm=None, verbose=False): - self.has_echo = False - self.verbose = verbose - - if cmdargs: - if '-echo' in cmdargs: - idx = cmdargs.index('-echo') - # ensures that echo line is ignored during output capture - self.has_echo = idx+1 < len(cmdargs) and cmdargs[idx+1] in ('screen', 'both') - - if ptr: - if isinstance(ptr,PyLammps): - self.lmp = ptr.lmp - elif isinstance(ptr,lammps): - self.lmp = ptr - else: - self.lmp = lammps(name=name,cmdargs=cmdargs,ptr=ptr,comm=comm) - else: - self.lmp = lammps(name=name,cmdargs=cmdargs,ptr=None,comm=comm) - print("LAMMPS output is captured by PyLammps wrapper") - self._cmd_history = [] - self._enable_cmd_history = False - self.runs = [] - - def __enter__(self): - return self - - def __exit__(self, ex_type, ex_value, ex_traceback): - self.close() - - def __del__(self): - if self.lmp: self.lmp.close() - self.lmp = None - - def close(self): - """Explicitly delete a LAMMPS instance - - This is a wrapper around the :py:meth:`lammps.close` of the Python interface. - """ - if self.lmp: self.lmp.close() - self.lmp = None - - def version(self): - """Return a numerical representation of the LAMMPS version in use. - - This is a wrapper around the :py:meth:`lammps.version` function of the Python interface. - - :return: version number - :rtype: int - """ - return self.lmp.version() - - def file(self, file): - """Read LAMMPS commands from a file. - - This is a wrapper around the :py:meth:`lammps.file` function of the Python interface. - - :param path: Name of the file/path with LAMMPS commands - :type path: string - """ - self.lmp.file(file) - - @property - def enable_cmd_history(self): - """ - :getter: Return whether command history is saved - :setter: Set if command history should be saved - :type: bool - """ - return self._enable_cmd_history - - @enable_cmd_history.setter - def enable_cmd_history(self, value): - """ - :getter: Return whether command history is saved - :setter: Set if command history should be saved - :type: bool - """ - self._enable_cmd_history = (value == True) - - def write_script(self, filepath): - """ - Write LAMMPS script file containing all commands executed up until now - - :param filepath: path to script file that should be written - :type filepath: string - """ - with open(filepath, "w") as f: - for cmd in self._cmd_history: - print(cmd, file=f) - - def clear_cmd_history(self): - """ - Clear LAMMPS command history up to this point - """ - self._cmd_history = [] - - def command(self, cmd): - """ - Execute LAMMPS command - - If :py:attr:`PyLammps.enable_cmd_history` is set to ``True``, commands executed - will be recorded. The entire command history can be written to a file using - :py:meth:`PyLammps.write_script()`. To clear the command history, use - :py:meth:`PyLammps.clear_cmd_history()`. - - :param cmd: command string that should be executed - :type: cmd: string - """ - self.lmp.command(cmd) - - if self.enable_cmd_history: - self._cmd_history.append(cmd) - - def run(self, *args, **kwargs): - """ - Execute LAMMPS run command with given arguments - - All thermo output during the run is captured and saved as new entry in - :py:attr:`PyLammps.runs`. The latest run can be retrieved by - :py:attr:`PyLammps.last_run`. - """ - output = self.__getattr__('run')(*args, **kwargs) - self.runs += get_thermo_data(output) - return output - - @property - def last_run(self): - """ - Return data produced of last completed run command - - :getter: Returns an object containing information about the last run command - :type: dict - """ - if len(self.runs) > 0: - return self.runs[-1] - return None - - @property - def atoms(self): - """ - All atoms of this LAMMPS instance - - :getter: Returns a list of atoms currently in the system - :type: AtomList - """ - return AtomList(self) - - @property - def system(self): - """ - The system state of this LAMMPS instance - - :getter: Returns an object with properties storing the current system state - :type: namedtuple - """ - output = self.lmp_info("system") - output = output[output.index("System information:")+1:] - d = self._parse_info_system(output) - return namedtuple('System', d.keys())(*d.values()) - - @property - def communication(self): - """ - The communication state of this LAMMPS instance - - :getter: Returns an object with properties storing the current communication state - :type: namedtuple - """ - output = self.lmp_info("communication") - output = output[output.index("Communication information:")+1:] - d = self._parse_info_communication(output) - return namedtuple('Communication', d.keys())(*d.values()) - - @property - def computes(self): - """ - The list of active computes of this LAMMPS instance - - :getter: Returns a list of computes that are currently active in this LAMMPS instance - :type: list - """ - output = self.lmp_info("computes") - output = output[output.index("Compute information:")+1:] - return self._parse_element_list(output) - - @property - def dumps(self): - """ - The list of active dumps of this LAMMPS instance - - :getter: Returns a list of dumps that are currently active in this LAMMPS instance - :type: list - """ - output = self.lmp_info("dumps") - output = output[output.index("Dump information:")+1:] - return self._parse_element_list(output) - - @property - def fixes(self): - """ - The list of active fixes of this LAMMPS instance - - :getter: Returns a list of fixes that are currently active in this LAMMPS instance - :type: list - """ - output = self.lmp_info("fixes") - output = output[output.index("Fix information:")+1:] - return self._parse_element_list(output) - - @property - def groups(self): - """ - The list of active atom groups of this LAMMPS instance - - :getter: Returns a list of atom groups that are currently active in this LAMMPS instance - :type: list - """ - output = self.lmp_info("groups") - output = output[output.index("Group information:")+1:] - return self._parse_groups(output) - - @property - def variables(self): - """ - Returns a dictionary of all variables defined in the current LAMMPS instance - - :getter: Returns a dictionary of all variables that are defined in this LAMMPS instance - :type: dict - """ - output = self.lmp_info("variables") - output = output[output.index("Variable information:")+1:] - variables = {} - for v in self._parse_element_list(output): - variables[v['name']] = Variable(self, v['name'], v['style'], v['def']) - return variables - - def eval(self, expr): - """ - Evaluate expression - - :param expr: the expression string that should be evaluated inside of LAMMPS - :type expr: string - - :return: the value of the evaluated expression - :rtype: float if numeric, string otherwise - """ - value = self.lmp_print('"$(%s)"' % expr).strip() - try: - return float(value) - except ValueError: - return value - - def _split_values(self, line): - return [x.strip() for x in line.split(',')] - - def _get_pair(self, value): - return [x.strip() for x in value.split('=')] - - def _parse_info_system(self, output): - system = {} - - for line in output: - if line.startswith("Units"): - system['units'] = self._get_pair(line)[1] - elif line.startswith("Atom style"): - system['atom_style'] = self._get_pair(line)[1] - elif line.startswith("Atom map"): - system['atom_map'] = self._get_pair(line)[1] - elif line.startswith("Atoms"): - parts = self._split_values(line) - system['natoms'] = int(self._get_pair(parts[0])[1]) - system['ntypes'] = int(self._get_pair(parts[1])[1]) - system['style'] = self._get_pair(parts[2])[1] - elif line.startswith("Kspace style"): - system['kspace_style'] = self._get_pair(line)[1] - elif line.startswith("Dimensions"): - system['dimensions'] = int(self._get_pair(line)[1]) - elif line.startswith("Orthogonal box"): - system['orthogonal_box'] = [float(x) for x in self._get_pair(line)[1].split('x')] - elif line.startswith("Boundaries"): - system['boundaries'] = self._get_pair(line)[1] - elif line.startswith("xlo"): - keys, values = [self._split_values(x) for x in self._get_pair(line)] - for key, value in zip(keys, values): - system[key] = float(value) - elif line.startswith("ylo"): - keys, values = [self._split_values(x) for x in self._get_pair(line)] - for key, value in zip(keys, values): - system[key] = float(value) - elif line.startswith("zlo"): - keys, values = [self._split_values(x) for x in self._get_pair(line)] - for key, value in zip(keys, values): - system[key] = float(value) - elif line.startswith("Molecule type"): - system['molecule_type'] = self._get_pair(line)[1] - elif line.startswith("Bonds"): - parts = self._split_values(line) - system['nbonds'] = int(self._get_pair(parts[0])[1]) - system['nbondtypes'] = int(self._get_pair(parts[1])[1]) - system['bond_style'] = self._get_pair(parts[2])[1] - elif line.startswith("Angles"): - parts = self._split_values(line) - system['nangles'] = int(self._get_pair(parts[0])[1]) - system['nangletypes'] = int(self._get_pair(parts[1])[1]) - system['angle_style'] = self._get_pair(parts[2])[1] - elif line.startswith("Dihedrals"): - parts = self._split_values(line) - system['ndihedrals'] = int(self._get_pair(parts[0])[1]) - system['ndihedraltypes'] = int(self._get_pair(parts[1])[1]) - system['dihedral_style'] = self._get_pair(parts[2])[1] - elif line.startswith("Impropers"): - parts = self._split_values(line) - system['nimpropers'] = int(self._get_pair(parts[0])[1]) - system['nimpropertypes'] = int(self._get_pair(parts[1])[1]) - system['improper_style'] = self._get_pair(parts[2])[1] - - return system - - def _parse_info_communication(self, output): - comm = {} - - for line in output: - if line.startswith("MPI library"): - comm['mpi_version'] = line.split(':')[1].strip() - elif line.startswith("Comm style"): - parts = self._split_values(line) - comm['comm_style'] = self._get_pair(parts[0])[1] - comm['comm_layout'] = self._get_pair(parts[1])[1] - elif line.startswith("Processor grid"): - comm['proc_grid'] = [int(x) for x in self._get_pair(line)[1].split('x')] - elif line.startswith("Communicate velocities for ghost atoms"): - comm['ghost_velocity'] = (self._get_pair(line)[1] == "yes") - elif line.startswith("Nprocs"): - parts = self._split_values(line) - comm['nprocs'] = int(self._get_pair(parts[0])[1]) - comm['nthreads'] = int(self._get_pair(parts[1])[1]) - return comm - - def _parse_element_list(self, output): - elements = [] - - for line in output: - if not line or (":" not in line): continue - element_info = self._split_values(line.split(':')[1].strip()) - element = {'name': element_info[0]} - for key, value in [self._get_pair(x) for x in element_info[1:]]: - element[key] = value - elements.append(element) - return elements - - def _parse_groups(self, output): - groups = [] - group_pattern = re.compile(r"(?P.+) \((?P.+)\)") - - for line in output: - m = group_pattern.match(line.split(':')[1].strip()) - group = {'name': m.group('name'), 'type': m.group('type')} - groups.append(group) - return groups - - def lmp_print(self, s): - """ needed for Python2 compatibility, since print is a reserved keyword """ - return self.__getattr__("print")(s) - - def __dir__(self): - return sorted(set(['angle_coeff', 'angle_style', 'atom_modify', 'atom_style', 'atom_style', - 'bond_coeff', 'bond_style', 'boundary', 'change_box', 'communicate', 'compute', - 'create_atoms', 'create_box', 'delete_atoms', 'delete_bonds', 'dielectric', - 'dihedral_coeff', 'dihedral_style', 'dimension', 'dump', 'fix', 'fix_modify', - 'group', 'improper_coeff', 'improper_style', 'include', 'kspace_modify', - 'kspace_style', 'lattice', 'mass', 'minimize', 'min_style', 'neighbor', - 'neigh_modify', 'newton', 'nthreads', 'pair_coeff', 'pair_modify', - 'pair_style', 'processors', 'read', 'read_data', 'read_restart', 'region', - 'replicate', 'reset_timestep', 'restart', 'run', 'run_style', 'thermo', - 'thermo_modify', 'thermo_style', 'timestep', 'undump', 'unfix', 'units', - 'variable', 'velocity', 'write_restart'] + self.lmp.available_styles("command"))) - - def lmp_info(self, s): - # skip anything before and after Info-Info-Info - # also skip timestamp line - output = self.__getattr__("info")(s) - indices = [index for index, line in enumerate(output) if line.startswith("Info-Info-Info-Info")] - start = indices[0] - end = indices[1] - return [line for line in output[start+2:end] if line] - - def __getattr__(self, name): - """ - This method is where the Python 'magic' happens. If a method is not - defined by the class PyLammps, it assumes it is a LAMMPS command. It takes - all the arguments, concatinates them to a single string, and executes it using - :py:meth:`lammps.PyLammps.command()`. - - :param verbose: Print output of command - :type verbose: bool - :return: line or list of lines of output, None if no output - :rtype: list or string - """ - def handler(*args, **kwargs): - cmd_args = [name] + [str(x) for x in args] - self.lmp.flush_buffers() - - with OutputCapture() as capture: - cmd = ' '.join(cmd_args) - self.command(cmd) - self.lmp.flush_buffers() - output = capture.output - - comm = self.lmp.get_mpi_comm() - if comm: - output = self.lmp.comm.bcast(output, root=0) - - if self.verbose or ('verbose' in kwargs and kwargs['verbose']): - print(output, end = '') - - lines = output.splitlines() - - if self.has_echo: - lines = lines[1:] - - if len(lines) > 1: - return lines - elif len(lines) == 1: - return lines[0] - return None - - return handler - - -class IPyLammps(PyLammps): - """ - IPython wrapper for LAMMPS which adds embedded graphics capabilities to PyLammmps interface - - It either creates its own instance of :py:class:`lammps` or can be - initialized with an existing instance. The arguments are the same of the - lower-level interface. The original interface can still be accessed via - :py:attr:`PyLammps.lmp`. - - :param name: "machine" name of the shared LAMMPS library ("mpi" loads ``liblammps_mpi.so``, "" loads ``liblammps.so``) - :type name: string - :param cmdargs: list of command line arguments to be passed to the :cpp:func:`lammps_open` function. The executable name is automatically added. - :type cmdargs: list - :param ptr: pointer to a LAMMPS C++ class instance when called from an embedded Python interpreter. None means load symbols from shared library. - :type ptr: pointer - :param comm: MPI communicator (as provided by `mpi4py `_). ``None`` means use ``MPI_COMM_WORLD`` implicitly. - :type comm: MPI_Comm - """ - - def __init__(self,name="",cmdargs=None,ptr=None,comm=None): - super(IPyLammps, self).__init__(name=name,cmdargs=cmdargs,ptr=ptr,comm=comm) - - def image(self, filename="snapshot.png", group="all", color="type", diameter="type", - size=None, view=None, center=None, up=None, zoom=1.0, background_color="white"): - """ Generate image using write_dump command and display it - - See :doc:`dump image ` for more information. - - :param filename: Name of the image file that should be generated. The extension determines whether it is PNG or JPEG - :type filename: string - :param group: the group of atoms write_image should use - :type group: string - :param color: name of property used to determine color - :type color: string - :param diameter: name of property used to determine atom diameter - :type diameter: string - :param size: dimensions of image - :type size: tuple (width, height) - :param view: view parameters - :type view: tuple (theta, phi) - :param center: center parameters - :type center: tuple (flag, center_x, center_y, center_z) - :param up: vector pointing to up direction - :type up: tuple (up_x, up_y, up_z) - :param zoom: zoom factor - :type zoom: float - :param background_color: background color of scene - :type background_color: string - - :return: Image instance used to display image in notebook - :rtype: :py:class:`IPython.core.display.Image` - """ - cmd_args = [group, "image", filename, color, diameter] - - if size is not None: - width = size[0] - height = size[1] - cmd_args += ["size", width, height] - - if view is not None: - theta = view[0] - phi = view[1] - cmd_args += ["view", theta, phi] - - if center is not None: - flag = center[0] - Cx = center[1] - Cy = center[2] - Cz = center[3] - cmd_args += ["center", flag, Cx, Cy, Cz] - - if up is not None: - Ux = up[0] - Uy = up[1] - Uz = up[2] - cmd_args += ["up", Ux, Uy, Uz] - - if zoom is not None: - cmd_args += ["zoom", zoom] - - cmd_args.append("modify backcolor " + background_color) - - self.write_dump(*cmd_args) - from IPython.core.display import Image - return Image(filename) - - def video(self, filename): - """ - Load video from file - - Can be used to visualize videos from :doc:`dump movie `. - - :param filename: Path to video file - :type filename: string - :return: HTML Video Tag used by notebook to embed a video - :rtype: :py:class:`IPython.display.HTML` - """ - from IPython.display import HTML - return HTML("") From b4fc400ed315adae49f890a4c01256f15ef96583 Mon Sep 17 00:00:00 2001 From: rohskopf Date: Thu, 7 Jul 2022 17:14:04 -0600 Subject: [PATCH 555/585] Add python/lammps back --- python/lammps/__init__.py | 49 + python/lammps/constants.py | 48 + python/lammps/core.py | 2097 +++++++++++++++++++++++++++++++ python/lammps/data.py | 92 ++ python/lammps/formats.py | 227 ++++ python/lammps/mliap/__init__.py | 20 + python/lammps/mliap/loader.py | 52 + python/lammps/mliap/pytorch.py | 326 +++++ python/lammps/numpy_wrapper.py | 483 +++++++ python/lammps/pylammps.py | 990 +++++++++++++++ 10 files changed, 4384 insertions(+) create mode 100644 python/lammps/__init__.py create mode 100644 python/lammps/constants.py create mode 100644 python/lammps/core.py create mode 100644 python/lammps/data.py create mode 100644 python/lammps/formats.py create mode 100644 python/lammps/mliap/__init__.py create mode 100644 python/lammps/mliap/loader.py create mode 100644 python/lammps/mliap/pytorch.py create mode 100644 python/lammps/numpy_wrapper.py create mode 100644 python/lammps/pylammps.py diff --git a/python/lammps/__init__.py b/python/lammps/__init__.py new file mode 100644 index 0000000000..fc35e45225 --- /dev/null +++ b/python/lammps/__init__.py @@ -0,0 +1,49 @@ +""" +LAMMPS module global members: + +.. data:: __version__ + + Numerical representation of the LAMMPS version this + module was taken from. Has the same format as the + result of :py:func:`lammps.version`. +""" + +from .constants import * # lgtm [py/polluting-import] +from .core import * # lgtm [py/polluting-import] +from .data import * # lgtm [py/polluting-import] +from .pylammps import * # lgtm [py/polluting-import] + +# convert installed module string version to numeric version +def get_version_number(): + import time + from os.path import join + from sys import version_info + + # must report 0 when inside LAMMPS source tree + if __file__.find(join('python', 'lammps', '__init__.py')) > 0: + return 0 + + vstring = None + if version_info.major == 3 and version_info.minor >= 8: + from importlib.metadata import version, PackageNotFoundError + try: + vstring = version('lammps') + except PackageNotFoundError: + # nothing to do, ignore + pass + + else: + from pkg_resources import get_distribution, DistributionNotFound + try: + vstring = get_distribution('lammps').version + except DistributionNotFound: + # nothing to do, ignore + pass + + if not vstring: + return 0 + + t = time.strptime(vstring, "%Y.%m.%d") + return t.tm_year*10000 + t.tm_mon*100 + t.tm_mday + +__version__ = get_version_number() diff --git a/python/lammps/constants.py b/python/lammps/constants.py new file mode 100644 index 0000000000..a50d58b28f --- /dev/null +++ b/python/lammps/constants.py @@ -0,0 +1,48 @@ +# ---------------------------------------------------------------------- +# LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator +# https://www.lammps.org/ Sandia National Laboratories +# Steve Plimpton, sjplimp@sandia.gov +# +# Copyright (2003) Sandia Corporation. Under the terms of Contract +# DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains +# certain rights in this software. This software is distributed under +# the GNU General Public License. +# +# See the README file in the top-level LAMMPS directory. +# ------------------------------------------------------------------------- + +# various symbolic constants to be used +# in certain calls to select data formats +LAMMPS_AUTODETECT = None +LAMMPS_INT = 0 +LAMMPS_INT_2D = 1 +LAMMPS_DOUBLE = 2 +LAMMPS_DOUBLE_2D = 3 +LAMMPS_INT64 = 4 +LAMMPS_INT64_2D = 5 +LAMMPS_STRING = 6 + +# these must be kept in sync with the enums in library.h +LMP_STYLE_GLOBAL = 0 +LMP_STYLE_ATOM = 1 +LMP_STYLE_LOCAL = 2 + +LMP_TYPE_SCALAR = 0 +LMP_TYPE_VECTOR = 1 +LMP_TYPE_ARRAY = 2 +LMP_SIZE_VECTOR = 3 +LMP_SIZE_ROWS = 4 +LMP_SIZE_COLS = 5 + +LMP_VAR_EQUAL = 0 +LMP_VAR_ATOM = 1 + +# ------------------------------------------------------------------------- + +def get_ctypes_int(size): + from ctypes import c_int, c_int32, c_int64 + if size == 4: + return c_int32 + elif size == 8: + return c_int64 + return c_int diff --git a/python/lammps/core.py b/python/lammps/core.py new file mode 100644 index 0000000000..930a40a4b0 --- /dev/null +++ b/python/lammps/core.py @@ -0,0 +1,2097 @@ +# ---------------------------------------------------------------------- +# LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator +# https://www.lammps.org/ Sandia National Laboratories +# Steve Plimpton, sjplimp@sandia.gov +# +# Copyright (2003) Sandia Corporation. Under the terms of Contract +# DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains +# certain rights in this software. This software is distributed under +# the GNU General Public License. +# +# See the README file in the top-level LAMMPS directory. +# ------------------------------------------------------------------------- +# Python wrapper for the LAMMPS library via ctypes + +# for python2/3 compatibility + +from __future__ import print_function + +import os +import sys +from ctypes import * # lgtm [py/polluting-import] +from os.path import dirname,abspath,join +from inspect import getsourcefile + +from .constants import * # lgtm [py/polluting-import] +from .data import * # lgtm [py/polluting-import] + +# ------------------------------------------------------------------------- + +class MPIAbortException(Exception): + def __init__(self, message): + self.message = message + + def __str__(self): + return repr(self.message) + +# ------------------------------------------------------------------------- + +class ExceptionCheck: + """Utility class to rethrow LAMMPS C++ exceptions as Python exceptions""" + def __init__(self, lmp): + self.lmp = lmp + + def __enter__(self): + pass + + def __exit__(self, exc_type, exc_value, traceback): + if self.lmp.has_exceptions and self.lmp.lib.lammps_has_error(self.lmp.lmp): + raise self.lmp._lammps_exception + +# ------------------------------------------------------------------------- + +class lammps(object): + """Create an instance of the LAMMPS Python class. + + .. _mpi4py_docs: https://mpi4py.readthedocs.io/ + + This is a Python wrapper class that exposes the LAMMPS C-library + interface to Python. It either requires that LAMMPS has been compiled + as shared library which is then dynamically loaded via the ctypes + Python module or that this module called from a Python function that + is called from a Python interpreter embedded into a LAMMPS executable, + for example through the :doc:`python invoke ` command. + When the class is instantiated it calls the :cpp:func:`lammps_open` + function of the LAMMPS C-library interface, which in + turn will create an instance of the :cpp:class:`LAMMPS ` + C++ class. The handle to this C++ class is stored internally + and automatically passed to the calls to the C library interface. + + :param name: "machine" name of the shared LAMMPS library ("mpi" loads ``liblammps_mpi.so``, "" loads ``liblammps.so``) + :type name: string + :param cmdargs: list of command line arguments to be passed to the :cpp:func:`lammps_open` function. The executable name is automatically added. + :type cmdargs: list + :param ptr: pointer to a LAMMPS C++ class instance when called from an embedded Python interpreter. None means load symbols from shared library. + :type ptr: pointer + :param comm: MPI communicator (as provided by `mpi4py `_). ``None`` means use ``MPI_COMM_WORLD`` implicitly. + :type comm: MPI_Comm + """ + + # ------------------------------------------------------------------------- + # create an instance of LAMMPS + + def __init__(self,name='',cmdargs=None,ptr=None,comm=None): + self.comm = comm + self.opened = 0 + + # determine module file location + + modpath = dirname(abspath(getsourcefile(lambda:0))) + # for windows installers the shared library is in a different folder + winpath = abspath(os.path.join(modpath,'..','..','bin')) + # allow override for running tests on Windows + if (os.environ.get("LAMMPSDLLPATH")): + winpath = os.environ.get("LAMMPSDLLPATH") + self.lib = None + self.lmp = None + + # if a pointer to a LAMMPS object is handed in + # when being called from a Python interpreter + # embedded into a LAMMPS executable, all library + # symbols should already be available so we do not + # load a shared object. + + try: + if ptr is not None: self.lib = CDLL("",RTLD_GLOBAL) + except OSError: + self.lib = None + + # load liblammps.so unless name is given + # if name = "g++", load liblammps_g++.so + # try loading the LAMMPS shared object from the location + # of the lammps package with an absolute path, + # so that LD_LIBRARY_PATH does not need to be set for regular install + # fall back to loading with a relative path, + # typically requires LD_LIBRARY_PATH to be set appropriately + # guess shared library extension based on OS, if not inferred from actual file + + if any([f.startswith('liblammps') and f.endswith('.dylib') + for f in os.listdir(modpath)]): + lib_ext = ".dylib" + elif any([f.startswith('liblammps') and f.endswith('.dll') + for f in os.listdir(modpath)]): + lib_ext = ".dll" + elif os.path.exists(winpath) and any([f.startswith('liblammps') and f.endswith('.dll') + for f in os.listdir(winpath)]): + lib_ext = ".dll" + modpath = winpath + elif any([f.startswith('liblammps') and f.endswith('.so') + for f in os.listdir(modpath)]): + lib_ext = ".so" + else: + import platform + if platform.system() == "Darwin": + lib_ext = ".dylib" + elif platform.system() == "Windows": + lib_ext = ".dll" + else: + lib_ext = ".so" + + if not self.lib: + if name: + libpath = join(modpath,"liblammps_%s" % name + lib_ext) + else: + libpath = join(modpath,"liblammps" + lib_ext) + if not os.path.isfile(libpath): + if name: + libpath = "liblammps_%s" % name + lib_ext + else: + libpath = "liblammps" + lib_ext + self.lib = CDLL(libpath,RTLD_GLOBAL) + + # declare all argument and return types for all library methods here. + # exceptions are where the arguments depend on certain conditions and + # then are defined where the functions are used. + self.lib.lammps_extract_setting.argtypes = [c_void_p, c_char_p] + self.lib.lammps_extract_setting.restype = c_int + + # set default types + # needed in later declarations + self.c_bigint = get_ctypes_int(self.extract_setting("bigint")) + self.c_tagint = get_ctypes_int(self.extract_setting("tagint")) + self.c_imageint = get_ctypes_int(self.extract_setting("imageint")) + + self.lib.lammps_open.restype = c_void_p + self.lib.lammps_open_no_mpi.restype = c_void_p + self.lib.lammps_close.argtypes = [c_void_p] + self.lib.lammps_flush_buffers.argtypes = [c_void_p] + self.lib.lammps_free.argtypes = [c_void_p] + + self.lib.lammps_file.argtypes = [c_void_p, c_char_p] + self.lib.lammps_file.restype = None + + self.lib.lammps_command.argtypes = [c_void_p, c_char_p] + self.lib.lammps_command.restype = c_char_p + self.lib.lammps_commands_list.restype = None + self.lib.lammps_commands_string.argtypes = [c_void_p, c_char_p] + self.lib.lammps_commands_string.restype = None + + self.lib.lammps_get_natoms.argtypes = [c_void_p] + self.lib.lammps_get_natoms.restype = c_double + self.lib.lammps_extract_box.argtypes = \ + [c_void_p,POINTER(c_double),POINTER(c_double), + POINTER(c_double),POINTER(c_double),POINTER(c_double), + POINTER(c_int),POINTER(c_int)] + self.lib.lammps_extract_box.restype = None + + self.lib.lammps_reset_box.argtypes = \ + [c_void_p,POINTER(c_double),POINTER(c_double),c_double,c_double,c_double] + self.lib.lammps_reset_box.restype = None + + self.lib.lammps_gather_atoms.argtypes = [c_void_p,c_char_p,c_int,c_int,c_void_p] + self.lib.lammps_gather_atoms.restype = None + + self.lib.lammps_gather_atoms_concat.argtypes = [c_void_p,c_char_p,c_int,c_int,c_void_p] + self.lib.lammps_gather_atoms_concat.restype = None + + self.lib.lammps_gather_atoms_subset.argtypes = \ + [c_void_p,c_char_p,c_int,c_int,c_int,POINTER(c_int),c_void_p] + self.lib.lammps_gather_atoms_subset.restype = None + + self.lib.lammps_scatter_atoms.argtypes = [c_void_p,c_char_p,c_int,c_int,c_void_p] + self.lib.lammps_scatter_atoms.restype = None + + self.lib.lammps_scatter_atoms_subset.argtypes = \ + [c_void_p,c_char_p,c_int,c_int,c_int,POINTER(c_int),c_void_p] + self.lib.lammps_scatter_atoms_subset.restype = None + + self.lib.lammps_gather_bonds.argtypes = [c_void_p,c_void_p] + self.lib.lammps_gather_bonds.restype = None + + self.lib.lammps_gather.argtypes = [c_void_p,c_char_p,c_int,c_int,c_void_p] + self.lib.lammps_gather.restype = None + + self.lib.lammps_gather_concat.argtypes = [c_void_p,c_char_p,c_int,c_int,c_void_p] + self.lib.lammps_gather_concat.restype = None + + self.lib.lammps_gather_subset.argtypes = \ + [c_void_p,c_char_p,c_int,c_int,c_int,POINTER(c_int),c_void_p] + self.lib.lammps_gather_subset.restype = None + + self.lib.lammps_scatter.argtypes = [c_void_p,c_char_p,c_int,c_int,c_void_p] + self.lib.lammps_scatter.restype = None + + self.lib.lammps_scatter_subset.argtypes = \ + [c_void_p,c_char_p,c_int,c_int,c_int,POINTER(c_int),c_void_p] + self.lib.lammps_scatter_subset.restype = None + + + self.lib.lammps_find_pair_neighlist.argtypes = [c_void_p, c_char_p, c_int, c_int, c_int] + self.lib.lammps_find_pair_neighlist.restype = c_int + + self.lib.lammps_find_fix_neighlist.argtypes = [c_void_p, c_char_p, c_int] + self.lib.lammps_find_fix_neighlist.restype = c_int + + self.lib.lammps_find_compute_neighlist.argtypes = [c_void_p, c_char_p, c_int] + self.lib.lammps_find_compute_neighlist.restype = c_int + + self.lib.lammps_neighlist_num_elements.argtypes = [c_void_p, c_int] + self.lib.lammps_neighlist_num_elements.restype = c_int + + self.lib.lammps_neighlist_element_neighbors.argtypes = \ + [c_void_p, c_int, c_int, POINTER(c_int), POINTER(c_int), POINTER(POINTER(c_int))] + self.lib.lammps_neighlist_element_neighbors.restype = None + + self.lib.lammps_is_running.argtypes = [c_void_p] + self.lib.lammps_is_running.restype = c_int + + self.lib.lammps_force_timeout.argtypes = [c_void_p] + + self.lib.lammps_has_error.argtypes = [c_void_p] + self.lib.lammps_has_error.restype = c_int + + self.lib.lammps_get_last_error_message.argtypes = [c_void_p, c_char_p, c_int] + self.lib.lammps_get_last_error_message.restype = c_int + + self.lib.lammps_extract_global.argtypes = [c_void_p, c_char_p] + self.lib.lammps_extract_global_datatype.argtypes = [c_void_p, c_char_p] + self.lib.lammps_extract_global_datatype.restype = c_int + self.lib.lammps_extract_compute.argtypes = [c_void_p, c_char_p, c_int, c_int] + + self.lib.lammps_get_thermo.argtypes = [c_void_p, c_char_p] + self.lib.lammps_get_thermo.restype = c_double + + self.lib.lammps_encode_image_flags.restype = self.c_imageint + + self.lib.lammps_config_package_name.argtypes = [c_int, c_char_p, c_int] + self.lib.lammps_config_accelerator.argtypes = [c_char_p, c_char_p, c_char_p] + + self.lib.lammps_set_variable.argtypes = [c_void_p, c_char_p, c_char_p] + + self.lib.lammps_has_style.argtypes = [c_void_p, c_char_p, c_char_p] + + self.lib.lammps_style_count.argtypes = [c_void_p, c_char_p] + + self.lib.lammps_style_name.argtypes = [c_void_p, c_char_p, c_int, c_char_p, c_int] + + self.lib.lammps_has_id.argtypes = [c_void_p, c_char_p, c_char_p] + + self.lib.lammps_id_count.argtypes = [c_void_p, c_char_p] + + self.lib.lammps_id_name.argtypes = [c_void_p, c_char_p, c_int, c_char_p, c_int] + + self.lib.lammps_plugin_count.argtypes = [ ] + self.lib.lammps_plugin_name.argtypes = [c_int, c_char_p, c_char_p, c_int] + + self.lib.lammps_version.argtypes = [c_void_p] + + self.lib.lammps_get_os_info.argtypes = [c_char_p, c_int] + self.lib.lammps_get_gpu_device_info.argtypes = [c_char_p, c_int] + + self.lib.lammps_get_mpi_comm.argtypes = [c_void_p] + + self.lib.lammps_decode_image_flags.argtypes = [self.c_imageint, POINTER(c_int*3)] + + self.lib.lammps_extract_atom.argtypes = [c_void_p, c_char_p] + self.lib.lammps_extract_atom_datatype.argtypes = [c_void_p, c_char_p] + self.lib.lammps_extract_atom_datatype.restype = c_int + + self.lib.lammps_extract_fix.argtypes = [c_void_p, c_char_p, c_int, c_int, c_int, c_int] + + self.lib.lammps_extract_variable.argtypes = [c_void_p, c_char_p, c_char_p] + + self.lib.lammps_fix_external_get_force.argtypes = [c_void_p, c_char_p] + self.lib.lammps_fix_external_get_force.restype = POINTER(POINTER(c_double)) + + self.lib.lammps_fix_external_set_energy_global.argtypes = [c_void_p, c_char_p, c_double] + self.lib.lammps_fix_external_set_virial_global.argtypes = [c_void_p, c_char_p, POINTER(c_double)] + self.lib.lammps_fix_external_set_energy_peratom.argtypes = [c_void_p, c_char_p, POINTER(c_double)] + self.lib.lammps_fix_external_set_virial_peratom.argtypes = [c_void_p, c_char_p, POINTER(POINTER(c_double))] + + self.lib.lammps_fix_external_set_vector_length.argtypes = [c_void_p, c_char_p, c_int] + self.lib.lammps_fix_external_set_vector.argtypes = [c_void_p, c_char_p, c_int, c_double] + + # detect if Python is using a version of mpi4py that can pass communicators + # only needed if LAMMPS has been compiled with MPI support. + self.has_mpi4py = False + if self.has_mpi_support: + try: + from mpi4py import __version__ as mpi4py_version + # tested to work with mpi4py versions 2 and 3 + self.has_mpi4py = mpi4py_version.split('.')[0] in ['2','3'] + except ImportError: + # ignore failing import + pass + + # if no ptr provided, create an instance of LAMMPS + # we can pass an MPI communicator from mpi4py v2.0.0 and later + # no_mpi call lets LAMMPS use MPI_COMM_WORLD + # cargs = array of C strings from args + # if ptr, then are embedding Python in LAMMPS input script + # ptr is the desired instance of LAMMPS + # just convert it to ctypes ptr and store in self.lmp + + if ptr is None: + + # with mpi4py v2+, we can pass MPI communicators to LAMMPS + # need to adjust for type of MPI communicator object + # allow for int (like MPICH) or void* (like OpenMPI) + if self.has_mpi_support and self.has_mpi4py: + from mpi4py import MPI + self.MPI = MPI + + if comm is not None: + if not self.has_mpi_support: + raise Exception('LAMMPS not compiled with real MPI library') + if not self.has_mpi4py: + raise Exception('Python mpi4py version is not 2 or 3') + if self.MPI._sizeof(self.MPI.Comm) == sizeof(c_int): + MPI_Comm = c_int + else: + MPI_Comm = c_void_p + + # Detect whether LAMMPS and mpi4py definitely use different MPI libs + if sizeof(MPI_Comm) != self.lib.lammps_config_has_mpi_support(): + raise Exception('Inconsistent MPI library in LAMMPS and mpi4py') + + narg = 0 + cargs = None + if cmdargs is not None: + cmdargs.insert(0,"lammps") + narg = len(cmdargs) + for i in range(narg): + if type(cmdargs[i]) is str: + cmdargs[i] = cmdargs[i].encode() + cargs = (c_char_p*narg)(*cmdargs) + self.lib.lammps_open.argtypes = [c_int, c_char_p*narg, MPI_Comm, c_void_p] + else: + self.lib.lammps_open.argtypes = [c_int, c_char_p, MPI_Comm, c_void_p] + + self.opened = 1 + comm_ptr = self.MPI._addressof(comm) + comm_val = MPI_Comm.from_address(comm_ptr) + self.lmp = c_void_p(self.lib.lammps_open(narg,cargs,comm_val,None)) + + else: + if self.has_mpi4py and self.has_mpi_support: + self.comm = self.MPI.COMM_WORLD + self.opened = 1 + if cmdargs is not None: + cmdargs.insert(0,"lammps") + narg = len(cmdargs) + for i in range(narg): + if type(cmdargs[i]) is str: + cmdargs[i] = cmdargs[i].encode() + cargs = (c_char_p*narg)(*cmdargs) + self.lib.lammps_open_no_mpi.argtypes = [c_int, c_char_p*narg, c_void_p] + self.lmp = c_void_p(self.lib.lammps_open_no_mpi(narg,cargs,None)) + else: + self.lib.lammps_open_no_mpi.argtypes = [c_int, c_char_p, c_void_p] + self.lmp = c_void_p(self.lib.lammps_open_no_mpi(0,None,None)) + + else: + # magic to convert ptr to ctypes ptr + if sys.version_info >= (3, 0): + # Python 3 (uses PyCapsule API) + pythonapi.PyCapsule_GetPointer.restype = c_void_p + pythonapi.PyCapsule_GetPointer.argtypes = [py_object, c_char_p] + self.lmp = c_void_p(pythonapi.PyCapsule_GetPointer(ptr, None)) + else: + # Python 2 (uses PyCObject API) + pythonapi.PyCObject_AsVoidPtr.restype = c_void_p + pythonapi.PyCObject_AsVoidPtr.argtypes = [py_object] + self.lmp = c_void_p(pythonapi.PyCObject_AsVoidPtr(ptr)) + + # check if library initilialization failed + if not self.lmp: + raise(RuntimeError("Failed to initialize LAMMPS object")) + + # optional numpy support (lazy loading) + self._numpy = None + + self._installed_packages = None + self._available_styles = None + + # check if liblammps version matches the installed python module version + # but not for in-place usage, i.e. when the version is 0 + import lammps + if lammps.__version__ > 0 and lammps.__version__ != self.lib.lammps_version(self.lmp): + raise(AttributeError("LAMMPS Python module installed for LAMMPS version %d, but shared library is version %d" \ + % (lammps.__version__, self.lib.lammps_version(self.lmp)))) + + # add way to insert Python callback for fix external + self.callback = {} + self.FIX_EXTERNAL_CALLBACK_FUNC = CFUNCTYPE(None, py_object, self.c_bigint, c_int, POINTER(self.c_tagint), POINTER(POINTER(c_double)), POINTER(POINTER(c_double))) + self.lib.lammps_set_fix_external_callback.argtypes = [c_void_p, c_char_p, self.FIX_EXTERNAL_CALLBACK_FUNC, py_object] + self.lib.lammps_set_fix_external_callback.restype = None + + # ------------------------------------------------------------------------- + # shut-down LAMMPS instance + + def __del__(self): + self.close() + + # ------------------------------------------------------------------------- + # context manager implementation + + def __enter__(self): + return self + + def __exit__(self, ex_type, ex_value, ex_traceback): + self.close() + + # ------------------------------------------------------------------------- + + @property + def numpy(self): + """ Return object to access numpy versions of API + + It provides alternative implementations of API functions that + return numpy arrays instead of ctypes pointers. If numpy is not installed, + accessing this property will lead to an ImportError. + + :return: instance of numpy wrapper object + :rtype: numpy_wrapper + """ + if not self._numpy: + from .numpy_wrapper import numpy_wrapper + self._numpy = numpy_wrapper(self) + return self._numpy + + # ------------------------------------------------------------------------- + + def close(self): + """Explicitly delete a LAMMPS instance through the C-library interface. + + This is a wrapper around the :cpp:func:`lammps_close` function of the C-library interface. + """ + if self.lmp and self.opened: + self.lib.lammps_close(self.lmp) + self.lmp = None + self.opened = 0 + + # ------------------------------------------------------------------------- + + def finalize(self): + """Shut down the MPI communication and Kokkos environment (if active) through the + library interface by calling :cpp:func:`lammps_mpi_finalize` and + :cpp:func:`lammps_kokkos_finalize`. + + You cannot create or use any LAMMPS instances after this function is called + unless LAMMPS was compiled without MPI and without Kokkos support. + """ + self.close() + self.lib.lammps_kokkos_finalize() + self.lib.lammps_mpi_finalize() + + # ------------------------------------------------------------------------- + + def version(self): + """Return a numerical representation of the LAMMPS version in use. + + This is a wrapper around the :cpp:func:`lammps_version` function of the C-library interface. + + :return: version number + :rtype: int + """ + return self.lib.lammps_version(self.lmp) + + # ------------------------------------------------------------------------- + + def get_os_info(self): + """Return a string with information about the OS and compiler runtime + + This is a wrapper around the :cpp:func:`lammps_get_os_info` function of the C-library interface. + + :return: OS info string + :rtype: string + """ + + sb = create_string_buffer(512) + self.lib.lammps_get_os_info(sb,512) + return sb.value.decode() + + # ------------------------------------------------------------------------- + + def get_mpi_comm(self): + """Get the MPI communicator in use by the current LAMMPS instance + + This is a wrapper around the :cpp:func:`lammps_get_mpi_comm` function + of the C-library interface. It will return ``None`` if either the + LAMMPS library was compiled without MPI support or the mpi4py + Python module is not available. + + :return: MPI communicator + :rtype: MPI_Comm + """ + + if self.has_mpi4py and self.has_mpi_support: + from mpi4py import MPI + f_comm = self.lib.lammps_get_mpi_comm(self.lmp) + c_comm = MPI.Comm.f2py(f_comm) + return c_comm + else: + return None + + # ------------------------------------------------------------------------- + + @property + def _lammps_exception(self): + sb = create_string_buffer(100) + error_type = self.lib.lammps_get_last_error_message(self.lmp, sb, 100) + error_msg = sb.value.decode().strip() + + if error_type == 2: + return MPIAbortException(error_msg) + return Exception(error_msg) + + # ------------------------------------------------------------------------- + + def file(self, path): + """Read LAMMPS commands from a file. + + This is a wrapper around the :cpp:func:`lammps_file` function of the C-library interface. + It will open the file with the name/path `file` and process the LAMMPS commands line by line until + the end. The function will return when the end of the file is reached. + + :param path: Name of the file/path with LAMMPS commands + :type path: string + """ + if path: path = path.encode() + else: return + + with ExceptionCheck(self): + self.lib.lammps_file(self.lmp, path) + + # ------------------------------------------------------------------------- + + def command(self,cmd): + """Process a single LAMMPS input command from a string. + + This is a wrapper around the :cpp:func:`lammps_command` + function of the C-library interface. + + :param cmd: a single lammps command + :type cmd: string + """ + if cmd: cmd = cmd.encode() + else: return + + with ExceptionCheck(self): + self.lib.lammps_command(self.lmp,cmd) + + # ------------------------------------------------------------------------- + + def commands_list(self,cmdlist): + """Process multiple LAMMPS input commands from a list of strings. + + This is a wrapper around the + :cpp:func:`lammps_commands_list` function of + the C-library interface. + + :param cmdlist: a single lammps command + :type cmdlist: list of strings + """ + cmds = [x.encode() for x in cmdlist if type(x) is str] + narg = len(cmdlist) + args = (c_char_p * narg)(*cmds) + self.lib.lammps_commands_list.argtypes = [c_void_p, c_int, c_char_p * narg] + + with ExceptionCheck(self): + self.lib.lammps_commands_list(self.lmp,narg,args) + + # ------------------------------------------------------------------------- + + def commands_string(self,multicmd): + """Process a block of LAMMPS input commands from a string. + + This is a wrapper around the + :cpp:func:`lammps_commands_string` + function of the C-library interface. + + :param multicmd: text block of lammps commands + :type multicmd: string + """ + if type(multicmd) is str: multicmd = multicmd.encode() + + with ExceptionCheck(self): + self.lib.lammps_commands_string(self.lmp,c_char_p(multicmd)) + + # ------------------------------------------------------------------------- + + def get_natoms(self): + """Get the total number of atoms in the LAMMPS instance. + + Will be precise up to 53-bit signed integer due to the + underlying :cpp:func:`lammps_get_natoms` function returning a double. + + :return: number of atoms + :rtype: int + """ + return int(self.lib.lammps_get_natoms(self.lmp)) + + # ------------------------------------------------------------------------- + + def extract_box(self): + """Extract simulation box parameters + + This is a wrapper around the :cpp:func:`lammps_extract_box` function + of the C-library interface. Unlike in the C function, the result is + returned as a list. + + :return: list of the extracted data: boxlo, boxhi, xy, yz, xz, periodicity, box_change + :rtype: [ 3*double, 3*double, double, double, 3*int, int] + """ + boxlo = (3*c_double)() + boxhi = (3*c_double)() + xy = c_double() + yz = c_double() + xz = c_double() + periodicity = (3*c_int)() + box_change = c_int() + + with ExceptionCheck(self): + self.lib.lammps_extract_box(self.lmp,boxlo,boxhi, + byref(xy),byref(yz),byref(xz), + periodicity,byref(box_change)) + + boxlo = boxlo[:3] + boxhi = boxhi[:3] + xy = xy.value + yz = yz.value + xz = xz.value + periodicity = periodicity[:3] + box_change = box_change.value + + return boxlo,boxhi,xy,yz,xz,periodicity,box_change + + # ------------------------------------------------------------------------- + + def reset_box(self,boxlo,boxhi,xy,yz,xz): + """Reset simulation box parameters + + This is a wrapper around the :cpp:func:`lammps_reset_box` function + of the C-library interface. + + :param boxlo: new lower box boundaries + :type boxlo: list of 3 floating point numbers + :param boxhi: new upper box boundaries + :type boxhi: list of 3 floating point numbers + :param xy: xy tilt factor + :type xy: float + :param yz: yz tilt factor + :type yz: float + :param xz: xz tilt factor + :type xz: float + """ + cboxlo = (3*c_double)(*boxlo) + cboxhi = (3*c_double)(*boxhi) + with ExceptionCheck(self): + self.lib.lammps_reset_box(self.lmp,cboxlo,cboxhi,xy,yz,xz) + + # ------------------------------------------------------------------------- + + def get_thermo(self,name): + """Get current value of a thermo keyword + + This is a wrapper around the :cpp:func:`lammps_get_thermo` + function of the C-library interface. + + :param name: name of thermo keyword + :type name: string + :return: value of thermo keyword + :rtype: double or None + """ + if name: name = name.encode() + else: return None + + with ExceptionCheck(self): + return self.lib.lammps_get_thermo(self.lmp,name) + + # ------------------------------------------------------------------------- + + def extract_setting(self, name): + """Query LAMMPS about global settings that can be expressed as an integer. + + This is a wrapper around the :cpp:func:`lammps_extract_setting` + function of the C-library interface. Its documentation includes + a list of the supported keywords. + + :param name: name of the setting + :type name: string + :return: value of the setting + :rtype: int + """ + if name: name = name.encode() + else: return None + return int(self.lib.lammps_extract_setting(self.lmp,name)) + + # ------------------------------------------------------------------------- + # extract global info datatype + + def extract_global_datatype(self, name): + """Retrieve global property datatype from LAMMPS + + This is a wrapper around the :cpp:func:`lammps_extract_global_datatype` + function of the C-library interface. Its documentation includes a + list of the supported keywords. + This function returns ``None`` if the keyword is not + recognized. Otherwise it will return a positive integer value that + corresponds to one of the :ref:`data type ` + constants define in the :py:mod:`lammps` module. + + :param name: name of the property + :type name: string + :return: data type of global property, see :ref:`py_datatype_constants` + :rtype: int + """ + if name: name = name.encode() + else: return None + return self.lib.lammps_extract_global_datatype(self.lmp, name) + + # ------------------------------------------------------------------------- + # extract global info + + def extract_global(self, name, dtype=LAMMPS_AUTODETECT): + """Query LAMMPS about global settings of different types. + + This is a wrapper around the :cpp:func:`lammps_extract_global` function + of the C-library interface. Since there are no pointers in Python, this + method will - unlike the C function - return the value or a list of + values. The :cpp:func:`lammps_extract_global` documentation includes a + list of the supported keywords and their data types. + Since Python needs to know the data type to be able to interpret + the result, by default, this function will try to auto-detect the data type + by asking the library. You can also force a specific data type. For that + purpose the :py:mod:`lammps` module contains :ref:`data type ` + constants. This function returns ``None`` if either the keyword is not recognized, + or an invalid data type constant is used. + + :param name: name of the property + :type name: string + :param dtype: data type of the returned data (see :ref:`py_datatype_constants`) + :type dtype: int, optional + :return: value of the property or list of values or None + :rtype: int, float, list, or NoneType + """ + + if dtype == LAMMPS_AUTODETECT: + dtype = self.extract_global_datatype(name) + + # set length of vector for items that are not a scalar + vec_dict = { 'boxlo':3, 'boxhi':3, 'sublo':3, 'subhi':3, + 'sublo_lambda':3, 'subhi_lambda':3, 'periodicity':3 } + if name in vec_dict: + veclen = vec_dict[name] + elif name == 'respa_dt': + veclen = self.extract_global('respa_levels',LAMMPS_INT) + else: + veclen = 1 + + if name: name = name.encode() + else: return None + + if dtype == LAMMPS_INT: + self.lib.lammps_extract_global.restype = POINTER(c_int32) + target_type = int + elif dtype == LAMMPS_INT64: + self.lib.lammps_extract_global.restype = POINTER(c_int64) + target_type = int + elif dtype == LAMMPS_DOUBLE: + self.lib.lammps_extract_global.restype = POINTER(c_double) + target_type = float + elif dtype == LAMMPS_STRING: + self.lib.lammps_extract_global.restype = c_char_p + target_type = str + else: + target_type = None + + ptr = self.lib.lammps_extract_global(self.lmp, name) + if ptr: + if dtype == LAMMPS_STRING: + return ptr.decode('utf-8') + if veclen > 1: + result = [] + for i in range(0,veclen): + result.append(target_type(ptr[i])) + return result + else: return target_type(ptr[0]) + return None + + # ------------------------------------------------------------------------- + # extract per-atom info datatype + + def extract_atom_datatype(self, name): + """Retrieve per-atom property datatype from LAMMPS + + This is a wrapper around the :cpp:func:`lammps_extract_atom_datatype` + function of the C-library interface. Its documentation includes a + list of the supported keywords. + This function returns ``None`` if the keyword is not + recognized. Otherwise it will return an integer value that + corresponds to one of the :ref:`data type ` constants + defined in the :py:mod:`lammps` module. + + :param name: name of the property + :type name: string + :return: data type of per-atom property (see :ref:`py_datatype_constants`) + :rtype: int + """ + if name: name = name.encode() + else: return None + return self.lib.lammps_extract_atom_datatype(self.lmp, name) + + # ------------------------------------------------------------------------- + # extract per-atom info + + def extract_atom(self, name, dtype=LAMMPS_AUTODETECT): + """Retrieve per-atom properties from LAMMPS + + This is a wrapper around the :cpp:func:`lammps_extract_atom` + function of the C-library interface. Its documentation includes a + list of the supported keywords and their data types. + Since Python needs to know the data type to be able to interpret + the result, by default, this function will try to auto-detect the data type + by asking the library. You can also force a specific data type by setting ``dtype`` + to one of the :ref:`data type ` constants defined in the + :py:mod:`lammps` module. + This function returns ``None`` if either the keyword is not + recognized, or an invalid data type constant is used. + + .. note:: + + While the returned arrays of per-atom data are dimensioned + for the range [0:nmax] - as is the underlying storage - + the data is usually only valid for the range of [0:nlocal], + unless the property of interest is also updated for ghost + atoms. In some cases, this depends on a LAMMPS setting, see + for example :doc:`comm_modify vel yes `. + + :param name: name of the property + :type name: string + :param dtype: data type of the returned data (see :ref:`py_datatype_constants`) + :type dtype: int, optional + :return: requested data or ``None`` + :rtype: ctypes.POINTER(ctypes.c_int32), ctypes.POINTER(ctypes.POINTER(ctypes.c_int32)), + ctypes.POINTER(ctypes.c_int64), ctypes.POINTER(ctypes.POINTER(ctypes.c_int64)), + ctypes.POINTER(ctypes.c_double), ctypes.POINTER(ctypes.POINTER(ctypes.c_double)), + or NoneType + """ + if dtype == LAMMPS_AUTODETECT: + dtype = self.extract_atom_datatype(name) + + if name: name = name.encode() + else: return None + + if dtype == LAMMPS_INT: + self.lib.lammps_extract_atom.restype = POINTER(c_int32) + elif dtype == LAMMPS_INT_2D: + self.lib.lammps_extract_atom.restype = POINTER(POINTER(c_int32)) + elif dtype == LAMMPS_DOUBLE: + self.lib.lammps_extract_atom.restype = POINTER(c_double) + elif dtype == LAMMPS_DOUBLE_2D: + self.lib.lammps_extract_atom.restype = POINTER(POINTER(c_double)) + elif dtype == LAMMPS_INT64: + self.lib.lammps_extract_atom.restype = POINTER(c_int64) + elif dtype == LAMMPS_INT64_2D: + self.lib.lammps_extract_atom.restype = POINTER(POINTER(c_int64)) + else: return None + + ptr = self.lib.lammps_extract_atom(self.lmp, name) + if ptr: return ptr + else: return None + + + # ------------------------------------------------------------------------- + + def extract_compute(self,cid,cstyle,ctype): + """Retrieve data from a LAMMPS compute + + This is a wrapper around the :cpp:func:`lammps_extract_compute` + function of the C-library interface. + This function returns ``None`` if either the compute id is not + recognized, or an invalid combination of :ref:`cstyle ` + and :ref:`ctype ` constants is used. The + names and functionality of the constants are the same as for + the corresponding C-library function. For requests to return + a scalar or a size, the value is returned, otherwise a pointer. + + :param cid: compute ID + :type cid: string + :param cstyle: style of the data retrieve (global, atom, or local), see :ref:`py_style_constants` + :type cstyle: int + :param ctype: type or size of the returned data (scalar, vector, or array), see :ref:`py_type_constants` + :type ctype: int + :return: requested data as scalar, pointer to 1d or 2d double array, or None + :rtype: c_double, ctypes.POINTER(c_double), ctypes.POINTER(ctypes.POINTER(c_double)), or NoneType + """ + if cid: cid = cid.encode() + else: return None + + if ctype == LMP_TYPE_SCALAR: + if cstyle == LMP_STYLE_GLOBAL: + self.lib.lammps_extract_compute.restype = POINTER(c_double) + with ExceptionCheck(self): + ptr = self.lib.lammps_extract_compute(self.lmp,cid,cstyle,ctype) + return ptr[0] + elif cstyle == LMP_STYLE_ATOM: + return None + elif cstyle == LMP_STYLE_LOCAL: + self.lib.lammps_extract_compute.restype = POINTER(c_int) + with ExceptionCheck(self): + ptr = self.lib.lammps_extract_compute(self.lmp,cid,cstyle,ctype) + return ptr[0] + + elif ctype == LMP_TYPE_VECTOR: + self.lib.lammps_extract_compute.restype = POINTER(c_double) + with ExceptionCheck(self): + ptr = self.lib.lammps_extract_compute(self.lmp,cid,cstyle,ctype) + return ptr + + elif ctype == LMP_TYPE_ARRAY: + self.lib.lammps_extract_compute.restype = POINTER(POINTER(c_double)) + with ExceptionCheck(self): + ptr = self.lib.lammps_extract_compute(self.lmp,cid,cstyle,ctype) + return ptr + + elif ctype == LMP_SIZE_COLS: + if cstyle == LMP_STYLE_GLOBAL or cstyle == LMP_STYLE_ATOM or cstyle == LMP_STYLE_LOCAL: + self.lib.lammps_extract_compute.restype = POINTER(c_int) + with ExceptionCheck(self): + ptr = self.lib.lammps_extract_compute(self.lmp,cid,cstyle,ctype) + return ptr[0] + + elif ctype == LMP_SIZE_VECTOR or ctype == LMP_SIZE_ROWS: + if cstyle == LMP_STYLE_GLOBAL or cstyle == LMP_STYLE_LOCAL: + self.lib.lammps_extract_compute.restype = POINTER(c_int) + with ExceptionCheck(self): + ptr = self.lib.lammps_extract_compute(self.lmp,cid,cstyle,ctype) + return ptr[0] + + return None + + # ------------------------------------------------------------------------- + # extract fix info + # in case of global data, free memory for 1 double via lammps_free() + # double was allocated by library interface function + + def extract_fix(self,fid,fstyle,ftype,nrow=0,ncol=0): + """Retrieve data from a LAMMPS fix + + This is a wrapper around the :cpp:func:`lammps_extract_fix` + function of the C-library interface. + This function returns ``None`` if either the fix id is not + recognized, or an invalid combination of :ref:`fstyle ` + and :ref:`ftype ` constants is used. The + names and functionality of the constants are the same as for + the corresponding C-library function. For requests to return + a scalar or a size, the value is returned, also when accessing + global vectors or arrays, otherwise a pointer. + + :param fid: fix ID + :type fid: string + :param fstyle: style of the data retrieve (global, atom, or local), see :ref:`py_style_constants` + :type fstyle: int + :param ftype: type or size of the returned data (scalar, vector, or array), see :ref:`py_type_constants` + :type ftype: int + :param nrow: index of global vector element or row index of global array element + :type nrow: int + :param ncol: column index of global array element + :type ncol: int + :return: requested data or None + :rtype: c_double, ctypes.POINTER(c_double), ctypes.POINTER(ctypes.POINTER(c_double)), or NoneType + + """ + if fid: fid = fid.encode() + else: return None + + if fstyle == LMP_STYLE_GLOBAL: + if ftype in (LMP_TYPE_SCALAR, LMP_TYPE_VECTOR, LMP_TYPE_ARRAY): + self.lib.lammps_extract_fix.restype = POINTER(c_double) + with ExceptionCheck(self): + ptr = self.lib.lammps_extract_fix(self.lmp,fid,fstyle,ftype,nrow,ncol) + result = ptr[0] + self.lib.lammps_free(ptr) + return result + elif ftype in (LMP_SIZE_VECTOR, LMP_SIZE_ROWS, LMP_SIZE_COLS): + self.lib.lammps_extract_fix.restype = POINTER(c_int) + with ExceptionCheck(self): + ptr = self.lib.lammps_extract_fix(self.lmp,fid,fstyle,ftype,nrow,ncol) + return ptr[0] + else: + return None + + elif fstyle == LMP_STYLE_ATOM: + if ftype == LMP_TYPE_VECTOR: + self.lib.lammps_extract_fix.restype = POINTER(c_double) + elif ftype == LMP_TYPE_ARRAY: + self.lib.lammps_extract_fix.restype = POINTER(POINTER(c_double)) + elif ftype == LMP_SIZE_COLS: + self.lib.lammps_extract_fix.restype = POINTER(c_int) + else: + return None + with ExceptionCheck(self): + ptr = self.lib.lammps_extract_fix(self.lmp,fid,fstyle,ftype,nrow,ncol) + if ftype == LMP_SIZE_COLS: + return ptr[0] + else: + return ptr + + elif fstyle == LMP_STYLE_LOCAL: + if ftype == LMP_TYPE_VECTOR: + self.lib.lammps_extract_fix.restype = POINTER(c_double) + elif ftype == LMP_TYPE_ARRAY: + self.lib.lammps_extract_fix.restype = POINTER(POINTER(c_double)) + elif ftype in (LMP_TYPE_SCALAR, LMP_SIZE_VECTOR, LMP_SIZE_ROWS, LMP_SIZE_COLS): + self.lib.lammps_extract_fix.restype = POINTER(c_int) + else: + return None + with ExceptionCheck(self): + ptr = self.lib.lammps_extract_fix(self.lmp,fid,fstyle,ftype,nrow,ncol) + if ftype in (LMP_TYPE_VECTOR, LMP_TYPE_ARRAY): + return ptr + else: + return ptr[0] + else: + return None + + # ------------------------------------------------------------------------- + # extract variable info + # free memory for 1 double or 1 vector of doubles via lammps_free() + # for vector, must copy nlocal returned values to local c_double vector + # memory was allocated by library interface function + + def extract_variable(self, name, group=None, vartype=LMP_VAR_EQUAL): + """ Evaluate a LAMMPS variable and return its data + + This function is a wrapper around the function + :cpp:func:`lammps_extract_variable` of the C-library interface, + evaluates variable name and returns a copy of the computed data. + The memory temporarily allocated by the C-interface is deleted + after the data is copied to a Python variable or list. + The variable must be either an equal-style (or equivalent) + variable or an atom-style variable. The variable type has to + provided as ``vartype`` parameter which may be one of two constants: + ``LMP_VAR_EQUAL`` or ``LMP_VAR_ATOM``; it defaults to + equal-style variables. + The group parameter is only used for atom-style variables and + defaults to the group "all" if set to ``None``, which is the default. + + :param name: name of the variable to execute + :type name: string + :param group: name of group for atom-style variable + :type group: string, only for atom-style variables + :param vartype: type of variable, see :ref:`py_vartype_constants` + :type vartype: int + :return: the requested data + :rtype: c_double, (c_double), or NoneType + """ + if name: name = name.encode() + else: return None + if group: group = group.encode() + if vartype == LMP_VAR_EQUAL: + self.lib.lammps_extract_variable.restype = POINTER(c_double) + with ExceptionCheck(self): + ptr = self.lib.lammps_extract_variable(self.lmp,name,group) + if ptr: result = ptr[0] + else: return None + self.lib.lammps_free(ptr) + return result + elif vartype == LMP_VAR_ATOM: + nlocal = self.extract_global("nlocal") + result = (c_double*nlocal)() + self.lib.lammps_extract_variable.restype = POINTER(c_double) + with ExceptionCheck(self): + ptr = self.lib.lammps_extract_variable(self.lmp,name,group) + if ptr: + for i in range(nlocal): result[i] = ptr[i] + self.lib.lammps_free(ptr) + else: return None + return result + return None + + # ------------------------------------------------------------------------- + + def flush_buffers(self): + """Flush output buffers + + This is a wrapper around the :cpp:func:`lammps_flush_buffers` + function of the C-library interface. + """ + self.lib.lammps_flush_buffers(self.lmp) + + # ------------------------------------------------------------------------- + + def set_variable(self,name,value): + """Set a new value for a LAMMPS string style variable + + This is a wrapper around the :cpp:func:`lammps_set_variable` + function of the C-library interface. + + :param name: name of the variable + :type name: string + :param value: new variable value + :type value: any. will be converted to a string + :return: either 0 on success or -1 on failure + :rtype: int + """ + if name: name = name.encode() + else: return -1 + if value: value = str(value).encode() + else: return -1 + with ExceptionCheck(self): + return self.lib.lammps_set_variable(self.lmp,name,value) + + # ------------------------------------------------------------------------- + + # return vector of atom properties gathered across procs + # 3 variants to match src/library.cpp + # name = atom property recognized by LAMMPS in atom->extract() + # dtype = 0 for integer values, 1 for double values + # count = number of per-atom valus, 1 for type or charge, 3 for x or f + # returned data is a 1d vector - doc how it is ordered? + # NOTE: need to insure are converting to/from correct Python type + # e.g. for Python list or NumPy or ctypes + + def gather_atoms(self,name,dtype,count): + if name: name = name.encode() + natoms = self.get_natoms() + with ExceptionCheck(self): + if dtype == 0: + data = ((count*natoms)*c_int)() + self.lib.lammps_gather_atoms(self.lmp,name,dtype,count,data) + elif dtype == 1: + data = ((count*natoms)*c_double)() + self.lib.lammps_gather_atoms(self.lmp,name,dtype,count,data) + else: + return None + return data + + # ------------------------------------------------------------------------- + + def gather_atoms_concat(self,name,dtype,count): + if name: name = name.encode() + natoms = self.get_natoms() + with ExceptionCheck(self): + if dtype == 0: + data = ((count*natoms)*c_int)() + self.lib.lammps_gather_atoms_concat(self.lmp,name,dtype,count,data) + elif dtype == 1: + data = ((count*natoms)*c_double)() + self.lib.lammps_gather_atoms_concat(self.lmp,name,dtype,count,data) + else: + return None + return data + + def gather_atoms_subset(self,name,dtype,count,ndata,ids): + if name: name = name.encode() + with ExceptionCheck(self): + if dtype == 0: + data = ((count*ndata)*c_int)() + self.lib.lammps_gather_atoms_subset(self.lmp,name,dtype,count,ndata,ids,data) + elif dtype == 1: + data = ((count*ndata)*c_double)() + self.lib.lammps_gather_atoms_subset(self.lmp,name,dtype,count,ndata,ids,data) + else: + return None + return data + + # ------------------------------------------------------------------------- + + # scatter vector of atom properties across procs + # 2 variants to match src/library.cpp + # name = atom property recognized by LAMMPS in atom->extract() + # type = 0 for integer values, 1 for double values + # count = number of per-atom valus, 1 for type or charge, 3 for x or f + # assume data is of correct type and length, as created by gather_atoms() + # NOTE: need to insure are converting to/from correct Python type + # e.g. for Python list or NumPy or ctypes + + def scatter_atoms(self,name,dtype,count,data): + if name: name = name.encode() + with ExceptionCheck(self): + self.lib.lammps_scatter_atoms(self.lmp,name,dtype,count,data) + + # ------------------------------------------------------------------------- + + def scatter_atoms_subset(self,name,dtype,count,ndata,ids,data): + if name: name = name.encode() + with ExceptionCheck(self): + self.lib.lammps_scatter_atoms_subset(self.lmp,name,dtype,count,ndata,ids,data) + + + # ------------------------------------------------------------------------- + + def gather_bonds(self): + """Retrieve global list of bonds + + This is a wrapper around the :cpp:func:`lammps_gather_bonds` + function of the C-library interface. + + This function returns a tuple with the number of bonds and a + flat list of ctypes integer values with the bond type, bond atom1, + bond atom2 for each bond. + + .. versionadded:: 28Jul2021 + + :return: a tuple with the number of bonds and a list of c_int or c_long + :rtype: (int, 3*nbonds*c_tagint) + """ + nbonds = self.extract_global("nbonds") + with ExceptionCheck(self): + data = ((3*nbonds)*self.c_tagint)() + self.lib.lammps_gather_bonds(self.lmp,data) + return nbonds,data + + # ------------------------------------------------------------------------- + + # return vector of atom/compute/fix properties gathered across procs + # 3 variants to match src/library.cpp + # name = atom property recognized by LAMMPS in atom->extract() + # type = 0 for integer values, 1 for double values + # count = number of per-atom valus, 1 for type or charge, 3 for x or f + # returned data is a 1d vector - doc how it is ordered? + # NOTE: need to insure are converting to/from correct Python type + # e.g. for Python list or NumPy or ctypes + def gather(self,name,dtype,count): + if name: name = name.encode() + natoms = self.get_natoms() + with ExceptionCheck(self): + if dtype == 0: + data = ((count*natoms)*c_int)() + self.lib.lammps_gather(self.lmp,name,dtype,count,data) + elif dtype == 1: + data = ((count*natoms)*c_double)() + self.lib.lammps_gather(self.lmp,name,dtype,count,data) + else: + return None + return data + + def gather_concat(self,name,dtype,count): + if name: name = name.encode() + natoms = self.get_natoms() + with ExceptionCheck(self): + if dtype == 0: + data = ((count*natoms)*c_int)() + self.lib.lammps_gather_concat(self.lmp,name,dtype,count,data) + elif dtype == 1: + data = ((count*natoms)*c_double)() + self.lib.lammps_gather_concat(self.lmp,name,dtype,count,data) + else: + return None + return data + + def gather_subset(self,name,dtype,count,ndata,ids): + if name: name = name.encode() + with ExceptionCheck(self): + if dtype == 0: + data = ((count*ndata)*c_int)() + self.lib.lammps_gather_subset(self.lmp,name,dtype,count,ndata,ids,data) + elif dtype == 1: + data = ((count*ndata)*c_double)() + self.lib.lammps_gather_subset(self.lmp,name,dtype,count,ndata,ids,data) + else: + return None + return data + + # scatter vector of atom/compute/fix properties across procs + # 2 variants to match src/library.cpp + # name = atom property recognized by LAMMPS in atom->extract() + # type = 0 for integer values, 1 for double values + # count = number of per-atom valus, 1 for type or charge, 3 for x or f + # assume data is of correct type and length, as created by gather_atoms() + # NOTE: need to insure are converting to/from correct Python type + # e.g. for Python list or NumPy or ctypes + + def scatter(self,name,dtype,count,data): + if name: name = name.encode() + with ExceptionCheck(self): + self.lib.lammps_scatter(self.lmp,name,dtype,count,data) + + def scatter_subset(self,name,dtype,count,ndata,ids,data): + if name: name = name.encode() + with ExceptionCheck(self): + self.lib.lammps_scatter_subset(self.lmp,name,dtype,count,ndata,ids,data) + + # ------------------------------------------------------------------------- + + def encode_image_flags(self,ix,iy,iz): + """ convert 3 integers with image flags for x-, y-, and z-direction + into a single integer like it is used internally in LAMMPS + + This method is a wrapper around the :cpp:func:`lammps_encode_image_flags` + function of library interface. + + :param ix: x-direction image flag + :type ix: int + :param iy: y-direction image flag + :type iy: int + :param iz: z-direction image flag + :type iz: int + :return: encoded image flags + :rtype: lammps.c_imageint + """ + return self.lib.lammps_encode_image_flags(ix,iy,iz) + + # ------------------------------------------------------------------------- + + def decode_image_flags(self,image): + """ Convert encoded image flag integer into list of three regular integers. + + This method is a wrapper around the :cpp:func:`lammps_decode_image_flags` + function of library interface. + + :param image: encoded image flags + :type image: lammps.c_imageint + :return: list of three image flags in x-, y-, and z- direction + :rtype: list of 3 int + """ + + flags = (c_int*3)() + self.lib.lammps_decode_image_flags(image,byref(flags)) + + return [int(i) for i in flags] + + # ------------------------------------------------------------------------- + + # create N atoms on all procs + # N = global number of atoms + # id = ID of each atom (optional, can be None) + # type = type of each atom (1 to Ntypes) (required) + # x = coords of each atom as (N,3) array (required) + # v = velocity of each atom as (N,3) array (optional, can be None) + # NOTE: how could we insure are passing correct type to LAMMPS + # e.g. for Python list or NumPy, etc + # ditto for gather_atoms() above + + def create_atoms(self,n,id,type,x,v=None,image=None,shrinkexceed=False): + """ + Create N atoms from list of coordinates and properties + + This function is a wrapper around the :cpp:func:`lammps_create_atoms` + function of the C-library interface, and the behavior is similar except + that the *v*, *image*, and *shrinkexceed* arguments are optional and + default to *None*, *None*, and *False*, respectively. With *None* being + equivalent to a ``NULL`` pointer in C. + + The lists of coordinates, types, atom IDs, velocities, image flags can + be provided in any format that may be converted into the required + internal data types. Also the list may contain more than *N* entries, + but not fewer. In the latter case, the function will return without + attempting to create atoms. You may use the :py:func:`encode_image_flags + ` method to properly combine three integers + with image flags into a single integer. + + :param n: number of atoms for which data is provided + :type n: int + :param id: list of atom IDs with at least n elements or None + :type id: list of lammps.tagint + :param type: list of atom types + :type type: list of int + :param x: list of coordinates for x-, y-, and z (flat list of 3n entries) + :type x: list of float + :param v: list of velocities for x-, y-, and z (flat list of 3n entries) or None (optional) + :type v: list of float + :param image: list of encoded image flags (optional) + :type image: list of lammps.imageint + :param shrinkexceed: whether to expand shrink-wrap boundaries if atoms are outside the box (optional) + :type shrinkexceed: bool + :return: number of atoms created. 0 if insufficient or invalid data + :rtype: int + """ + if id is not None: + id_lmp = (self.c_tagint*n)() + try: + id_lmp[:] = id[0:n] + except ValueError: + return 0 + else: + id_lmp = None + + type_lmp = (c_int*n)() + try: + type_lmp[:] = type[0:n] + except ValueError: + return 0 + + three_n = 3*n + x_lmp = (c_double*three_n)() + try: + x_lmp[:] = x[0:three_n] + except ValueError: + return 0 + + if v is not None: + v_lmp = (c_double*(three_n))() + try: + v_lmp[:] = v[0:three_n] + except ValueError: + return 0 + else: + v_lmp = None + + if image is not None: + img_lmp = (self.c_imageint*n)() + try: + img_lmp[:] = image[0:n] + except ValueError: + return 0 + else: + img_lmp = None + + if shrinkexceed: + se_lmp = 1 + else: + se_lmp = 0 + + self.lib.lammps_create_atoms.argtypes = [c_void_p, c_int, POINTER(self.c_tagint*n), + POINTER(c_int*n), POINTER(c_double*three_n), + POINTER(c_double*three_n), + POINTER(self.c_imageint*n), c_int] + with ExceptionCheck(self): + return self.lib.lammps_create_atoms(self.lmp, n, id_lmp, type_lmp, x_lmp, v_lmp, img_lmp, se_lmp) + + # ------------------------------------------------------------------------- + + @property + def has_mpi_support(self): + """ Report whether the LAMMPS shared library was compiled with a + real MPI library or in serial. + + This is a wrapper around the :cpp:func:`lammps_config_has_mpi_support` + function of the library interface. + + :return: False when compiled with MPI STUBS, otherwise True + :rtype: bool + """ + return self.lib.lammps_config_has_mpi_support() != 0 + + # ------------------------------------------------------------------------- + + @property + def is_running(self): + """ Report whether being called from a function during a run or a minimization + + Various LAMMPS commands must not be called during an ongoing + run or minimization. This property allows to check for that. + This is a wrapper around the :cpp:func:`lammps_is_running` + function of the library interface. + + .. versionadded:: 9Oct2020 + + :return: True when called during a run otherwise false + :rtype: bool + """ + return self.lib.lammps_is_running(self.lmp) == 1 + + # ------------------------------------------------------------------------- + + def force_timeout(self): + """ Trigger an immediate timeout, i.e. a "soft stop" of a run. + + This function allows to cleanly stop an ongoing run or minimization + at the next loop iteration. + This is a wrapper around the :cpp:func:`lammps_force_timeout` + function of the library interface. + + .. versionadded:: 9Oct2020 + """ + self.lib.lammps_force_timeout(self.lmp) + + # ------------------------------------------------------------------------- + + @property + def has_exceptions(self): + """ Report whether the LAMMPS shared library was compiled with C++ + exceptions handling enabled + + This is a wrapper around the :cpp:func:`lammps_config_has_exceptions` + function of the library interface. + + :return: state of C++ exception support + :rtype: bool + """ + return self.lib.lammps_config_has_exceptions() != 0 + + # ------------------------------------------------------------------------- + + @property + def has_gzip_support(self): + """ Report whether the LAMMPS shared library was compiled with support + for reading and writing compressed files through ``gzip``. + + This is a wrapper around the :cpp:func:`lammps_config_has_gzip_support` + function of the library interface. + + :return: state of gzip support + :rtype: bool + """ + return self.lib.lammps_config_has_gzip_support() != 0 + + # ------------------------------------------------------------------------- + + @property + def has_png_support(self): + """ Report whether the LAMMPS shared library was compiled with support + for writing images in PNG format. + + This is a wrapper around the :cpp:func:`lammps_config_has_png_support` + function of the library interface. + + :return: state of PNG support + :rtype: bool + """ + return self.lib.lammps_config_has_png_support() != 0 + + # ------------------------------------------------------------------------- + + @property + def has_jpeg_support(self): + """ Report whether the LAMMPS shared library was compiled with support + for writing images in JPEG format. + + This is a wrapper around the :cpp:func:`lammps_config_has_jpeg_support` + function of the library interface. + + :return: state of JPEG support + :rtype: bool + """ + return self.lib.lammps_config_has_jpeg_support() != 0 + + # ------------------------------------------------------------------------- + + @property + def has_ffmpeg_support(self): + """ State of support for writing movies with ``ffmpeg`` in the LAMMPS shared library + + This is a wrapper around the :cpp:func:`lammps_config_has_ffmpeg_support` + function of the library interface. + + :return: state of ffmpeg support + :rtype: bool + """ + return self.lib.lammps_config_has_ffmpeg_support() != 0 + + # ------------------------------------------------------------------------- + + @property + def accelerator_config(self): + """ Return table with available accelerator configuration settings. + + This is a wrapper around the :cpp:func:`lammps_config_accelerator` + function of the library interface which loops over all known packages + and categories and returns enabled features as a nested dictionary + with all enabled settings as list of strings. + + :return: nested dictionary with all known enabled settings as list of strings + :rtype: dictionary + """ + + result = {} + for p in ['GPU', 'KOKKOS', 'INTEL', 'OPENMP']: + result[p] = {} + c = 'api' + result[p][c] = [] + for s in ['cuda', 'hip', 'phi', 'pthreads', 'opencl', 'openmp', 'serial']: + if self.lib.lammps_config_accelerator(p.encode(),c.encode(),s.encode()): + result[p][c].append(s) + c = 'precision' + result[p][c] = [] + for s in ['double', 'mixed', 'single']: + if self.lib.lammps_config_accelerator(p.encode(),c.encode(),s.encode()): + result[p][c].append(s) + return result + + # ------------------------------------------------------------------------- + + @property + def has_gpu_device(self): + """ Availability of GPU package compatible device + + This is a wrapper around the :cpp:func:`lammps_has_gpu_device` + function of the C library interface. + + :return: True if a GPU package compatible device is present, otherwise False + :rtype: bool + """ + return self.lib.lammps_has_gpu_device() != 0 + + # ------------------------------------------------------------------------- + + def get_gpu_device_info(self): + """Return a string with detailed information about any devices that are + usable by the GPU package. + + This is a wrapper around the :cpp:func:`lammps_get_gpu_device_info` + function of the C-library interface. + + :return: GPU device info string + :rtype: string + """ + + sb = create_string_buffer(8192) + self.lib.lammps_get_gpu_device_info(sb,8192) + return sb.value.decode() + + # ------------------------------------------------------------------------- + + @property + def installed_packages(self): + """ List of the names of enabled packages in the LAMMPS shared library + + This is a wrapper around the functions :cpp:func:`lammps_config_package_count` + and :cpp:func`lammps_config_package_name` of the library interface. + + :return + """ + if self._installed_packages is None: + self._installed_packages = [] + npackages = self.lib.lammps_config_package_count() + sb = create_string_buffer(100) + for idx in range(npackages): + self.lib.lammps_config_package_name(idx, sb, 100) + self._installed_packages.append(sb.value.decode()) + return self._installed_packages + + # ------------------------------------------------------------------------- + + def has_style(self, category, name): + """Returns whether a given style name is available in a given category + + This is a wrapper around the function :cpp:func:`lammps_has_style` + of the library interface. + + :param category: name of category + :type category: string + :param name: name of the style + :type name: string + + :return: true if style is available in given category + :rtype: bool + """ + return self.lib.lammps_has_style(self.lmp, category.encode(), name.encode()) != 0 + + # ------------------------------------------------------------------------- + + def available_styles(self, category): + """Returns a list of styles available for a given category + + This is a wrapper around the functions :cpp:func:`lammps_style_count()` + and :cpp:func:`lammps_style_name()` of the library interface. + + :param category: name of category + :type category: string + + :return: list of style names in given category + :rtype: list + """ + if self._available_styles is None: + self._available_styles = {} + + if category not in self._available_styles: + self._available_styles[category] = [] + with ExceptionCheck(self): + nstyles = self.lib.lammps_style_count(self.lmp, category.encode()) + sb = create_string_buffer(100) + for idx in range(nstyles): + with ExceptionCheck(self): + self.lib.lammps_style_name(self.lmp, category.encode(), idx, sb, 100) + self._available_styles[category].append(sb.value.decode()) + return self._available_styles[category] + + # ------------------------------------------------------------------------- + + def has_id(self, category, name): + """Returns whether a given ID name is available in a given category + + This is a wrapper around the function :cpp:func:`lammps_has_id` + of the library interface. + + .. versionadded:: 9Oct2020 + + :param category: name of category + :type category: string + :param name: name of the ID + :type name: string + + :return: true if ID is available in given category + :rtype: bool + """ + return self.lib.lammps_has_id(self.lmp, category.encode(), name.encode()) != 0 + + # ------------------------------------------------------------------------- + + def available_ids(self, category): + """Returns a list of IDs available for a given category + + This is a wrapper around the functions :cpp:func:`lammps_id_count()` + and :cpp:func:`lammps_id_name()` of the library interface. + + .. versionadded:: 9Oct2020 + + :param category: name of category + :type category: string + + :return: list of id names in given category + :rtype: list + """ + + categories = ['compute','dump','fix','group','molecule','region','variable'] + available_ids = [] + if category in categories: + num = self.lib.lammps_id_count(self.lmp, category.encode()) + sb = create_string_buffer(100) + for idx in range(num): + self.lib.lammps_id_name(self.lmp, category.encode(), idx, sb, 100) + available_ids.append(sb.value.decode()) + return available_ids + + # ------------------------------------------------------------------------- + + def available_plugins(self, category): + """Returns a list of plugins available for a given category + + This is a wrapper around the functions :cpp:func:`lammps_plugin_count()` + and :cpp:func:`lammps_plugin_name()` of the library interface. + + .. versionadded:: 10Mar2021 + + :return: list of style/name pairs of loaded plugins + :rtype: list + """ + + available_plugins = [] + num = self.lib.lammps_plugin_count(self.lmp) + sty = create_string_buffer(100) + nam = create_string_buffer(100) + for idx in range(num): + self.lib.lammps_plugin_name(idx, sty, nam, 100) + available_plugins.append([sty.value.decode(), nam.value.decode()]) + return available_plugins + + # ------------------------------------------------------------------------- + + def set_fix_external_callback(self, fix_id, callback, caller=None): + """Set the callback function for a fix external instance with a given fix ID. + + Optionally also set a reference to the calling object. + + This is a wrapper around the :cpp:func:`lammps_set_fix_external_callback` function + of the C-library interface. However this is set up to call a Python function with + the following arguments. + + .. code-block: python + + def func(object, ntimestep, nlocal, tag, x, f): + + - object is the value of the "caller" argument + - ntimestep is the current timestep + - nlocal is the number of local atoms on the current MPI process + - tag is a 1d NumPy array of integers representing the atom IDs of the local atoms + - x is a 2d NumPy array of doubles of the coordinates of the local atoms + - f is a 2d NumPy array of doubles of the forces on the local atoms that will be added + + .. versionchanged:: 28Jul2021 + + :param fix_id: Fix-ID of a fix external instance + :type: string + :param callback: Python function that will be called from fix external + :type: function + :param caller: reference to some object passed to the callback function + :type: object, optional + """ + import numpy as np + + def callback_wrapper(caller, ntimestep, nlocal, tag_ptr, x_ptr, fext_ptr): + tag = self.numpy.iarray(self.c_tagint, tag_ptr, nlocal, 1) + x = self.numpy.darray(x_ptr, nlocal, 3) + f = self.numpy.darray(fext_ptr, nlocal, 3) + callback(caller, ntimestep, nlocal, tag, x, f) + + cFunc = self.FIX_EXTERNAL_CALLBACK_FUNC(callback_wrapper) + cCaller = caller + + self.callback[fix_id] = { 'function': cFunc, 'caller': caller } + with ExceptionCheck(self): + self.lib.lammps_set_fix_external_callback(self.lmp, fix_id.encode(), cFunc, cCaller) + + # ------------------------------------------------------------------------- + + def fix_external_get_force(self, fix_id): + """Get access to the array with per-atom forces of a fix external instance with a given fix ID. + + This is a wrapper around the :cpp:func:`lammps_fix_external_get_force` function + of the C-library interface. + + .. versionadded:: 28Jul2021 + + :param fix_id: Fix-ID of a fix external instance + :type: string + :return: requested data + :rtype: ctypes.POINTER(ctypes.POINTER(ctypes.double)) + """ + + with ExceptionCheck(self): + return self.lib.lammps_fix_external_get_force(self.lmp, fix_id.encode()) + + # ------------------------------------------------------------------------- + + def fix_external_set_energy_global(self, fix_id, eng): + """Set the global energy contribution for a fix external instance with the given ID. + + This is a wrapper around the :cpp:func:`lammps_fix_external_set_energy_global` function + of the C-library interface. + + .. versionadded:: 28Jul2021 + + :param fix_id: Fix-ID of a fix external instance + :type: string + :param eng: potential energy value to be added by fix external + :type: float + """ + + with ExceptionCheck(self): + return self.lib.lammps_fix_external_set_energy_global(self.lmp, fix_id.encode(), eng) + + # ------------------------------------------------------------------------- + + def fix_external_set_virial_global(self, fix_id, virial): + """Set the global virial contribution for a fix external instance with the given ID. + + This is a wrapper around the :cpp:func:`lammps_fix_external_set_virial_global` function + of the C-library interface. + + .. versionadded:: 28Jul2021 + + :param fix_id: Fix-ID of a fix external instance + :type: string + :param eng: list of 6 floating point numbers with the virial to be added by fix external + :type: float + """ + + cvirial = (6*c_double)(*virial) + with ExceptionCheck(self): + return self.lib.lammps_fix_external_set_virial_global(self.lmp, fix_id.encode(), cvirial) + + # ------------------------------------------------------------------------- + + def fix_external_set_energy_peratom(self, fix_id, eatom): + """Set the per-atom energy contribution for a fix external instance with the given ID. + + This is a wrapper around the :cpp:func:`lammps_fix_external_set_energy_peratom` function + of the C-library interface. + + .. versionadded:: 28Jul2021 + + :param fix_id: Fix-ID of a fix external instance + :type: string + :param eatom: list of potential energy values for local atoms to be added by fix external + :type: float + """ + + nlocal = self.extract_setting('nlocal') + if len(eatom) < nlocal: + raise Exception('per-atom energy list length must be at least nlocal') + ceatom = (nlocal*c_double)(*eatom) + with ExceptionCheck(self): + return self.lib.lammps_fix_external_set_energy_peratom(self.lmp, fix_id.encode(), ceatom) + + # ------------------------------------------------------------------------- + + def fix_external_set_virial_peratom(self, fix_id, vatom): + """Set the per-atom virial contribution for a fix external instance with the given ID. + + This is a wrapper around the :cpp:func:`lammps_fix_external_set_virial_peratom` function + of the C-library interface. + + .. versionadded:: 28Jul2021 + + :param fix_id: Fix-ID of a fix external instance + :type: string + :param vatom: list of natoms lists with 6 floating point numbers to be added by fix external + :type: float + """ + + # copy virial data to C compatible buffer + nlocal = self.extract_setting('nlocal') + if len(vatom) < nlocal: + raise Exception('per-atom virial first dimension must be at least nlocal') + if len(vatom[0]) != 6: + raise Exception('per-atom virial second dimension must be 6') + vbuf = (c_double * 6) + vptr = POINTER(c_double) + c_virial = (vptr * nlocal)() + for i in range(nlocal): + c_virial[i] = vbuf() + for j in range(6): + c_virial[i][j] = vatom[i][j] + + with ExceptionCheck(self): + return self.lib.lammps_fix_external_set_virial_peratom(self.lmp, fix_id.encode(), c_virial) + + # ------------------------------------------------------------------------- + def fix_external_set_vector_length(self, fix_id, length): + """Set the vector length for a global vector stored with fix external for analysis + + This is a wrapper around the :cpp:func:`lammps_fix_external_set_vector_length` function + of the C-library interface. + + .. versionadded:: 28Jul2021 + + :param fix_id: Fix-ID of a fix external instance + :type: string + :param length: length of the global vector + :type: int + """ + + with ExceptionCheck(self): + return self.lib.lammps_fix_external_set_vector_length(self.lmp, fix_id.encode(), length) + + # ------------------------------------------------------------------------- + def fix_external_set_vector(self, fix_id, idx, val): + """Store a global vector value for a fix external instance with the given ID. + + This is a wrapper around the :cpp:func:`lammps_fix_external_set_vector` function + of the C-library interface. + + .. versionadded:: 28Jul2021 + + :param fix_id: Fix-ID of a fix external instance + :type: string + :param idx: 1-based index of the value in the global vector + :type: int + :param val: value to be stored in the global vector + :type: float + """ + + with ExceptionCheck(self): + return self.lib.lammps_fix_external_set_vector(self.lmp, fix_id.encode(), idx, val) + + # ------------------------------------------------------------------------- + + def get_neighlist(self, idx): + """Returns an instance of :class:`NeighList` which wraps access to the neighbor list with the given index + + See :py:meth:`lammps.numpy.get_neighlist() ` if you want to use + NumPy arrays instead of ``c_int`` pointers. + + :param idx: index of neighbor list + :type idx: int + :return: an instance of :class:`NeighList` wrapping access to neighbor list data + :rtype: NeighList + """ + if idx < 0: + return None + return NeighList(self, idx) + + # ------------------------------------------------------------------------- + + def get_neighlist_size(self, idx): + """Return the number of elements in neighbor list with the given index + + :param idx: neighbor list index + :type idx: int + :return: number of elements in neighbor list with index idx + :rtype: int + """ + return self.lib.lammps_neighlist_num_elements(self.lmp, idx) + + # ------------------------------------------------------------------------- + + def get_neighlist_element_neighbors(self, idx, element): + """Return data of neighbor list entry + + :param element: neighbor list index + :type element: int + :param element: neighbor list element index + :type element: int + :return: tuple with atom local index, number of neighbors and array of neighbor local atom indices + :rtype: (int, int, POINTER(c_int)) + """ + c_iatom = c_int() + c_numneigh = c_int() + c_neighbors = POINTER(c_int)() + self.lib.lammps_neighlist_element_neighbors(self.lmp, idx, element, byref(c_iatom), byref(c_numneigh), byref(c_neighbors)) + return c_iatom.value, c_numneigh.value, c_neighbors + + # ------------------------------------------------------------------------- + + def find_pair_neighlist(self, style, exact=True, nsub=0, reqid=0): + """Find neighbor list index of pair style neighbor list + + Search for a neighbor list requested by a pair style instance that + matches "style". If exact is True, the pair style name must match + exactly. If exact is False, the pair style name is matched against + "style" as regular expression or sub-string. If the pair style is a + hybrid pair style, the style is instead matched against the hybrid + sub-styles. If the same pair style is used as sub-style multiple + types, you must set nsub to a value n > 0 which indicates the nth + instance of that sub-style to be used (same as for the pair_coeff + command). The default value of 0 will fail to match in that case. + + Once the pair style instance has been identified, it may have + requested multiple neighbor lists. Those are uniquely identified by + a request ID > 0 as set by the pair style. Otherwise the request + ID is 0. + + :param style: name of pair style that should be searched for + :type style: string + :param exact: controls whether style should match exactly or only must be contained in pair style name, defaults to True + :type exact: bool, optional + :param nsub: match nsub-th hybrid sub-style, defaults to 0 + :type nsub: int, optional + :param reqid: list request id, > 0 in case there are more than one, defaults to 0 + :type reqid: int, optional + :return: neighbor list index if found, otherwise -1 + :rtype: int + + """ + style = style.encode() + exact = int(exact) + idx = self.lib.lammps_find_pair_neighlist(self.lmp, style, exact, nsub, reqid) + return idx + + # ------------------------------------------------------------------------- + + def find_fix_neighlist(self, fixid, reqid=0): + """Find neighbor list index of fix neighbor list + + The fix instance requesting the neighbor list is uniquely identified + by the fix ID. In case the fix has requested multiple neighbor + lists, those are uniquely identified by a request ID > 0 as set by + the fix. Otherwise the request ID is 0 (the default). + + :param fixid: name of fix + :type fixid: string + :param reqid: id of neighbor list request, in case there are more than one request, defaults to 0 + :type reqid: int, optional + :return: neighbor list index if found, otherwise -1 + :rtype: int + + """ + fixid = fixid.encode() + idx = self.lib.lammps_find_fix_neighlist(self.lmp, fixid, reqid) + return idx + + # ------------------------------------------------------------------------- + + def find_compute_neighlist(self, computeid, reqid=0): + """Find neighbor list index of compute neighbor list + + The compute instance requesting the neighbor list is uniquely + identified by the compute ID. In case the compute has requested + multiple neighbor lists, those are uniquely identified by a request + ID > 0 as set by the compute. Otherwise the request ID is 0 (the + default). + + :param computeid: name of compute + :type computeid: string + :param reqid: index of neighbor list request, in case there are more than one request, defaults to 0 + :type reqid: int, optional + :return: neighbor list index if found, otherwise -1 + :rtype: int + + """ + computeid = computeid.encode() + idx = self.lib.lammps_find_compute_neighlist(self.lmp, computeid, reqid) + return idx diff --git a/python/lammps/data.py b/python/lammps/data.py new file mode 100644 index 0000000000..731a8c514a --- /dev/null +++ b/python/lammps/data.py @@ -0,0 +1,92 @@ +# ---------------------------------------------------------------------- +# LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator +# https://www.lammps.org/ Sandia National Laboratories +# Steve Plimpton, sjplimp@sandia.gov +# +# Copyright (2003) Sandia Corporation. Under the terms of Contract +# DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains +# certain rights in this software. This software is distributed under +# the GNU General Public License. +# +# See the README file in the top-level LAMMPS directory. +# ------------------------------------------------------------------------- + +################################################################################ +# LAMMPS data structures +# Written by Richard Berger +################################################################################ + +class NeighList(object): + """This is a wrapper class that exposes the contents of a neighbor list. + + It can be used like a regular Python list. Each element is a tuple of: + + * the atom local index + * its number of neighbors + * and a pointer to an c_int array containing local atom indices of its + neighbors + + Internally it uses the lower-level LAMMPS C-library interface. + + :param lmp: reference to instance of :py:class:`lammps` + :type lmp: lammps + :param idx: neighbor list index + :type idx: int + """ + def __init__(self, lmp, idx): + self.lmp = lmp + self.idx = idx + + def __str__(self): + return "Neighbor List ({} atoms)".format(self.size) + + def __repr__(self): + return self.__str__() + + @property + def size(self): + """ + :return: number of elements in neighbor list + """ + return self.lmp.get_neighlist_size(self.idx) + + def get(self, element): + """ + Access a specific neighbor list entry. "element" must be a number from 0 to the size-1 of the list + + :return: tuple with atom local index, number of neighbors and ctypes pointer to neighbor's local atom indices + :rtype: (int, int, ctypes.POINTER(c_int)) + """ + iatom, numneigh, neighbors = self.lmp.get_neighlist_element_neighbors(self.idx, element) + return iatom, numneigh, neighbors + + # the methods below implement the iterator interface, so NeighList can be used like a regular Python list + + def __getitem__(self, element): + return self.get(element) + + def __len__(self): + return self.size + + def __iter__(self): + inum = self.size + + for ii in range(inum): + yield self.get(ii) + + def find(self, iatom): + """ + Find the neighbor list for a specific (local) atom iatom. + If there is no list for iatom, (-1, None) is returned. + + :return: tuple with number of neighbors and ctypes pointer to neighbor's local atom indices + :rtype: (int, ctypes.POINTER(c_int)) + """ + + inum = self.size + for ii in range(inum): + idx, numneigh, neighbors = self.get(ii) + if idx == iatom: + return numneigh, neighbors + + return -1, None diff --git a/python/lammps/formats.py b/python/lammps/formats.py new file mode 100644 index 0000000000..b7c267466f --- /dev/null +++ b/python/lammps/formats.py @@ -0,0 +1,227 @@ +# ---------------------------------------------------------------------- +# LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator +# https://www.lammps.org/ Sandia National Laboratories +# Steve Plimpton, sjplimp@sandia.gov +# +# Copyright (2003) Sandia Corporation. Under the terms of Contract +# DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains +# certain rights in this software. This software is distributed under +# the GNU General Public License. +# +# See the README file in the top-level LAMMPS directory. +# ------------------------------------------------------------------------- + +################################################################################ +# LAMMPS output formats +# Written by Richard Berger +# and Axel Kohlmeyer +################################################################################ + +import re + +has_yaml = False +try: + import yaml + has_yaml = True + try: + from yaml import CSafeLoader as Loader + except ImportError: + from yaml import SafeLoader as Loader +except ImportError: + # ignore here, raise an exception when trying to parse yaml instead + pass + +class LogFile: + """Reads LAMMPS log files and extracts the thermo information + + It supports the line, multi, and yaml thermo output styles. + + :param filename: path to log file + :type filename: str + + :ivar runs: List of LAMMPS runs in log file. Each run is a dictionary with + thermo fields as keys, storing the values over time + :ivar errors: List of error lines in log file + """ + + STYLE_DEFAULT = 0 + STYLE_MULTI = 1 + STYLE_YAML = 2 + + def __init__(self, filename): + alpha = re.compile(r'[a-df-zA-DF-Z]') # except e or E for floating-point numbers + kvpairs = re.compile(r'([a-zA-Z_0-9]+)\s+=\s*([0-9\.eE\-]+)') + style = LogFile.STYLE_DEFAULT + yamllog = "" + self.runs = [] + self.errors = [] + with open(filename, 'rt') as f: + in_thermo = False + in_data_section = False + for line in f: + if "ERROR" in line or "exited on signal" in line: + self.errors.append(line) + + elif re.match(r'^ *Step ', line): + in_thermo = True + in_data_section = True + keys = line.split() + current_run = {} + for k in keys: + current_run[k] = [] + + elif re.match(r'^(keywords:.*$|data:$|---$| - \[.*\]$)', line): + if not has_yaml: + raise Exception('Cannot process YAML format logs without the PyYAML Python module') + style = LogFile.STYLE_YAML + yamllog += line; + current_run = {} + + elif re.match(r'^\.\.\.$', line): + thermo = yaml.load(yamllog, Loader=Loader) + for k in thermo['keywords']: + current_run[k] = [] + for step in thermo['data']: + icol = 0 + for k in thermo['keywords']: + current_run[k].append(step[icol]) + icol += 1 + self.runs.append(current_run) + yamllog = "" + + elif re.match(r'^------* Step ', line): + if not in_thermo: + current_run = {'Step': [], 'CPU': []} + in_thermo = True + in_data_section = True + style = LogFile.STYLE_MULTI + str_step, str_cpu = line.strip('-\n').split('-----') + step = float(str_step.split()[1]) + cpu = float(str_cpu.split('=')[1].split()[0]) + current_run["Step"].append(step) + current_run["CPU"].append(cpu) + + elif line.startswith('Loop time of'): + in_thermo = False + if style != LogFile.STYLE_YAML: + self.runs.append(current_run) + + elif in_thermo and in_data_section: + if style == LogFile.STYLE_DEFAULT: + if alpha.search(line): + continue + for k, v in zip(keys, map(float, line.split())): + current_run[k].append(v) + + elif style == LogFile.STYLE_MULTI: + if '=' not in line: + in_data_section = False + continue + for k,v in kvpairs.findall(line): + if k not in current_run: + current_run[k] = [float(v)] + else: + current_run[k].append(float(v)) + +class AvgChunkFile: + """Reads files generated by fix ave/chunk + + :param filename: path to ave/chunk file + :type filename: str + + :ivar timesteps: List of timesteps stored in file + :ivar total_count: total count over time + :ivar chunks: List of chunks. Each chunk is a dictionary containing its ID, the coordinates, and the averaged quantities + """ + def __init__(self, filename): + with open(filename, 'rt') as f: + timestep = None + chunks_read = 0 + + self.timesteps = [] + self.total_count = [] + self.chunks = [] + + for lineno, line in enumerate(f): + if lineno == 0: + if not line.startswith("# Chunk-averaged data for fix"): + raise Exception("Chunk data reader only supports default avg/chunk headers!") + parts = line.split() + self.fix_name = parts[5] + self.group_name = parts[8] + continue + elif lineno == 1: + if not line.startswith("# Timestep Number-of-chunks Total-count"): + raise Exception("Chunk data reader only supports default avg/chunk headers!") + continue + elif lineno == 2: + if not line.startswith("#"): + raise Exception("Chunk data reader only supports default avg/chunk headers!") + columns = line.split()[1:] + ndim = line.count("Coord") + compress = 'OrigID' in line + if ndim > 0: + coord_start = columns.index("Coord1") + coord_end = columns.index("Coord%d" % ndim) + ncount_start = coord_end + 1 + data_start = ncount_start + 1 + else: + coord_start = None + coord_end = None + ncount_start = 2 + data_start = 3 + continue + + parts = line.split() + + if timestep is None: + timestep = int(parts[0]) + num_chunks = int(parts[1]) + total_count = float(parts[2]) + + self.timesteps.append(timestep) + self.total_count.append(total_count) + + for i in range(num_chunks): + self.chunks.append({ + 'coord' : [], + 'ncount' : [] + }) + elif chunks_read < num_chunks: + chunk = int(parts[0]) + ncount = float(parts[ncount_start]) + + if compress: + chunk_id = int(parts[1]) + else: + chunk_id = chunk + + current = self.chunks[chunk_id - 1] + current['id'] = chunk_id + current['ncount'].append(ncount) + + if ndim > 0: + coord = tuple(map(float, parts[coord_start:coord_end+1])) + current['coord'].append(coord) + + for i, data_column in list(enumerate(columns))[data_start:]: + value = float(parts[i]) + + if data_column in current: + current[data_column].append(value) + else: + current[data_column] = [value] + + chunks_read += 1 + assert chunk == chunks_read + else: + # do not support changing number of chunks + if not (num_chunks == int(parts[1])): + raise Exception("Currently, changing numbers of chunks are not supported.") + + timestep = int(parts[0]) + total_count = float(parts[2]) + chunks_read = 0 + + self.timesteps.append(timestep) + self.total_count.append(total_count) diff --git a/python/lammps/mliap/__init__.py b/python/lammps/mliap/__init__.py new file mode 100644 index 0000000000..57fe97d803 --- /dev/null +++ b/python/lammps/mliap/__init__.py @@ -0,0 +1,20 @@ + +# Check compatiblity of this build with the python shared library. +# If this fails, lammps will segfault because its library will +# try to improperly start up a new interpreter. +import sysconfig +import ctypes +library = sysconfig.get_config_vars('INSTSONAME')[0] +try: + pylib = ctypes.CDLL(library) +except OSError as e: + if pylib.endswith(".a"): + pylib.strip(".a") + ".so" + pylib = ctypes.CDLL(library) + else: + raise e +if not pylib.Py_IsInitialized(): + raise RuntimeError("This interpreter is not compatible with python-based mliap for LAMMPS.") +del sysconfig, ctypes, library, pylib + +from .loader import load_model, activate_mliappy diff --git a/python/lammps/mliap/loader.py b/python/lammps/mliap/loader.py new file mode 100644 index 0000000000..dff791bfc1 --- /dev/null +++ b/python/lammps/mliap/loader.py @@ -0,0 +1,52 @@ +# ---------------------------------------------------------------------- +# LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator +# https://www.lammps.org/ Sandia National Laboratories +# Steve Plimpton, sjplimp@sandia.gov +# +# Copyright (2003) Sandia Corporation. Under the terms of Contract +# DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains +# certain rights in this software. This software is distributed under +# the GNU General Public License. +# +# See the README file in the top-level LAMMPS directory. +# ------------------------------------------------------------------------- + +# ---------------------------------------------------------------------- +# Contributing author: Nicholas Lubbers (LANL) +# ------------------------------------------------------------------------- + + +import sys +import importlib.util +import importlib.machinery + +def activate_mliappy(lmp): + try: + # Begin Importlib magic to find the embedded python module + # This is needed because the filename for liblammps does not + # match the spec for normal python modules, wherein + # file names match with PyInit function names. + # Also, python normally doesn't look for extensions besides '.so' + # We fix both of these problems by providing an explict + # path to the extension module 'mliap_model_python_couple' in + + path = lmp.lib._name + loader = importlib.machinery.ExtensionFileLoader('mliap_model_python_couple', path) + spec = importlib.util.spec_from_loader('mliap_model_python_couple', loader) + module = importlib.util.module_from_spec(spec) + sys.modules['mliap_model_python_couple'] = module + spec.loader.exec_module(module) + # End Importlib magic to find the embedded python module + + except Exception as ee: + raise ImportError("Could not load ML-IAP python coupling module.") from ee + +def load_model(model): + try: + import mliap_model_python_couple + except ImportError as ie: + raise ImportError("ML-IAP python module must be activated before loading\n" + "the pair style. Call lammps.mliap.activate_mliappy(lmp)." + ) from ie + mliap_model_python_couple.load_from_python(model) + diff --git a/python/lammps/mliap/pytorch.py b/python/lammps/mliap/pytorch.py new file mode 100644 index 0000000000..9aa2da80f4 --- /dev/null +++ b/python/lammps/mliap/pytorch.py @@ -0,0 +1,326 @@ +# ---------------------------------------------------------------------- +# LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator +# https://www.lammps.org/ Sandia National Laboratories +# Steve Plimpton, sjplimp@sandia.gov +# +# Copyright (2003) Sandia Corporation. Under the terms of Contract +# DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains +# certain rights in this software. This software is distributed under +# the GNU General Public License. +# +# See the README file in the top-level LAMMPS directory. +# ------------------------------------------------------------------------- + +# ---------------------------------------------------------------------- +# Contributing author: Nicholas Lubbers (LANL) +# ------------------------------------------------------------------------- + +import numpy as np +import torch + +def calc_n_params(model): + """ + Returns the sum of two decimal numbers in binary digits. + + Parameters: + model (torch.nn.Module): Network model that maps descriptors to a per atom attribute + + Returns: + n_params (int): Number of NN model parameters + """ + return sum(p.nelement() for p in model.parameters()) + +class TorchWrapper(torch.nn.Module): + """ + A class to wrap Modules to ensure lammps mliap compatability. + + ... + + Attributes + ---------- + model : torch.nn.Module + Network model that maps descriptors to a per atom attribute + + device : torch.nn.Module (None) + Accelerator device + + dtype : torch.dtype (torch.float64) + Dtype to use on device + + n_params : torch.nn.Module (None) + Number of NN model parameters + + n_descriptors : int + Max number of per atom descriptors + + n_elements : int + Max number of elements + + + Methods + ------- + forward(descriptors, elems): + Feeds descriptors to network model to produce per atom energies and forces. + """ + + def __init__(self, model, n_descriptors, n_elements, n_params=None, device=None, dtype=torch.float64): + """ + Constructs all the necessary attributes for the network module. + + Parameters + ---------- + model : torch.nn.Module + Network model that maps descriptors to a per atom attribute + + n_descriptors : int + Max number of per atom descriptors + + n_elements : int + Max number of elements + + n_params : torch.nn.Module (None) + Number of NN model parameters + + device : torch.nn.Module (None) + Accelerator device + + dtype : torch.dtype (torch.float64) + Dtype to use on device + """ + + super().__init__() + + self.model = model + self.device = device + self.dtype = dtype + + # Put model on device and convert to dtype + self.to(self.dtype) + self.to(self.device) + + if n_params is None: + n_params = calc_n_params(model) + + self.n_params = n_params + self.n_descriptors = n_descriptors + self.n_elements = n_elements + + def forward(self, elems, descriptors, beta, energy): + """ + Takes element types and descriptors calculated via lammps and + calculates the per atom energies and forces. + + Parameters + ---------- + elems : numpy.array + Per atom element types + + descriptors : numpy.array + Per atom descriptors + + beta : numpy.array + Expired beta array to be filled with new betas + + energy : numpy.array + Expired per atom energy array to be filled with new per atom energy + (Note: This is a pointer to the lammps per atom energies) + + + Returns + ------- + None + """ + + descriptors = torch.from_numpy(descriptors).to(dtype=self.dtype, device=self.device).requires_grad_(True) + elems = torch.from_numpy(elems).to(dtype=torch.long, device=self.device) - 1 + + with torch.autograd.enable_grad(): + + energy_nn = self.model(descriptors, elems) + if energy_nn.ndim > 1: + energy_nn = energy_nn.flatten() + + beta_nn = torch.autograd.grad(energy_nn.sum(), descriptors)[0] + + beta[:] = beta_nn.detach().cpu().numpy().astype(np.float64) + energy[:] = energy_nn.detach().cpu().numpy().astype(np.float64) + + +class IgnoreElems(torch.nn.Module): + """ + A class to represent a NN model agnostic of element typing. + + ... + + Attributes + ---------- + subnet : torch.nn.Module + Network model that maps descriptors to a per atom attribute + + Methods + ------- + forward(descriptors, elems): + Feeds descriptors to network model + """ + + def __init__(self, subnet): + """ + Constructs all the necessary attributes for the network module. + + Parameters + ---------- + subnet : torch.nn.Module + Network model that maps descriptors to a per atom attribute + """ + + super().__init__() + self.subnet = subnet + + def forward(self, descriptors, elems): + """ + Feeds descriptors to network model + + Parameters + ---------- + descriptors : torch.tensor + Per atom descriptors + + elems : torch.tensor + Per atom element types + + Returns + ------- + self.subnet(descriptors) : torch.tensor + Per atom attribute computed by the network model + """ + + return self.subnet(descriptors) + + +class UnpackElems(torch.nn.Module): + """ + A class to represent a NN model pseudo-agnostic of element typing for + systems with multiple element typings. + + ... + + Attributes + ---------- + subnet : torch.nn.Module + Network model that maps descriptors to a per atom attribute + + n_types : int + Number of atom types used in training the NN model. + + Methods + ------- + forward(descriptors, elems): + Feeds descriptors to network model after adding zeros into + descriptor columns relating to different atom types + """ + + def __init__(self, subnet, n_types): + """ + Constructs all the necessary attributes for the network module. + + Parameters + ---------- + subnet : torch.nn.Module + Network model that maps descriptors to a per atom attribute. + + n_types : int + Number of atom types used in training the NN model. + """ + super().__init__() + self.subnet = subnet + self.n_types = n_types + + def forward(self, descriptors, elems): + """ + Feeds descriptors to network model after adding zeros into + descriptor columns relating to different atom types + + Parameters + ---------- + descriptors : torch.tensor + Per atom descriptors + + elems : torch.tensor + Per atom element types + + Returns + ------- + self.subnet(descriptors) : torch.tensor + Per atom attribute computed by the network model + """ + + unpacked_descriptors = torch.zeros(elems.shape[0], self.n_types, descriptors.shape[1], dtype=torch.float64) + for i, ind in enumerate(elems): + unpacked_descriptors[i, ind, :] = descriptors[i] + return self.subnet(torch.reshape(unpacked_descriptors, (elems.shape[0], -1)), elems) + + +class ElemwiseModels(torch.nn.Module): + """ + A class to represent a NN model dependent on element typing. + + ... + + Attributes + ---------- + subnets : list of torch.nn.Modules + Per element type network models that maps per element type + descriptors to a per atom attribute. + + n_types : int + Number of atom types used in training the NN model. + + Methods + ------- + forward(descriptors, elems): + Feeds descriptors to network model after adding zeros into + descriptor columns relating to different atom types + """ + + def __init__(self, subnets, n_types): + """ + Constructs all the necessary attributes for the network module. + + Parameters + ---------- + subnets : list of torch.nn.Modules + Per element type network models that maps per element + type descriptors to a per atom attribute. + + n_types : int + Number of atom types used in training the NN model. + """ + + super().__init__() + self.subnets = subnets + self.n_types = n_types + + def forward(self, descriptors, elems): + """ + Feeds descriptors to network model after adding zeros into + descriptor columns relating to different atom types + + Parameters + ---------- + descriptors : torch.tensor + Per atom descriptors + + elems : torch.tensor + Per atom element types + + Returns + ------- + self.subnets(descriptors) : torch.tensor + Per atom attribute computed by the network model + """ + + per_atom_attributes = torch.zeros(elems.size[0]) + given_elems, elem_indices = torch.unique(elems, return_inverse=True) + for i, elem in enumerate(given_elems): + per_atom_attribute[elem_indices == i] = self.subnets[elem](descriptors[elem_indices == i]) + return per_atom_attributes diff --git a/python/lammps/numpy_wrapper.py b/python/lammps/numpy_wrapper.py new file mode 100644 index 0000000000..ce0cb35e47 --- /dev/null +++ b/python/lammps/numpy_wrapper.py @@ -0,0 +1,483 @@ +# ---------------------------------------------------------------------- +# LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator +# https://www.lammps.org/ Sandia National Laboratories +# Steve Plimpton, sjplimp@sandia.gov +# +# Copyright (2003) Sandia Corporation. Under the terms of Contract +# DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains +# certain rights in this software. This software is distributed under +# the GNU General Public License. +# +# See the README file in the top-level LAMMPS directory. +# ------------------------------------------------------------------------- + +################################################################################ +# NumPy additions +# Written by Richard Berger +################################################################################ + +import warnings +from ctypes import POINTER, c_void_p, c_char_p, c_double, c_int, c_int32, c_int64, cast + + +from .constants import * # lgtm [py/polluting-import] +from .data import NeighList + + +class numpy_wrapper: + """lammps API NumPy Wrapper + + This is a wrapper class that provides additional methods on top of an + existing :py:class:`lammps` instance. The methods transform raw ctypes + pointers into NumPy arrays, which give direct access to the + original data while protecting against out-of-bounds accesses. + + There is no need to explicitly instantiate this class. Each instance + of :py:class:`lammps` has a :py:attr:`numpy ` property + that returns an instance. + + :param lmp: instance of the :py:class:`lammps` class + :type lmp: lammps + """ + def __init__(self, lmp): + self.lmp = lmp + + # ------------------------------------------------------------------------- + + def _ctype_to_numpy_int(self, ctype_int): + import numpy as np + if ctype_int == c_int32: + return np.int32 + elif ctype_int == c_int64: + return np.int64 + return np.intc + + # ------------------------------------------------------------------------- + + def extract_atom(self, name, dtype=LAMMPS_AUTODETECT, nelem=LAMMPS_AUTODETECT, dim=LAMMPS_AUTODETECT): + """Retrieve per-atom properties from LAMMPS as NumPy arrays + + This is a wrapper around the :py:meth:`lammps.extract_atom()` method. + It behaves the same as the original method, but returns NumPy arrays + instead of ``ctypes`` pointers. + + .. note:: + + While the returned arrays of per-atom data are dimensioned + for the range [0:nmax] - as is the underlying storage - + the data is usually only valid for the range of [0:nlocal], + unless the property of interest is also updated for ghost + atoms. In some cases, this depends on a LAMMPS setting, see + for example :doc:`comm_modify vel yes `. + + :param name: name of the property + :type name: string + :param dtype: type of the returned data (see :ref:`py_datatype_constants`) + :type dtype: int, optional + :param nelem: number of elements in array + :type nelem: int, optional + :param dim: dimension of each element + :type dim: int, optional + :return: requested data as NumPy array with direct access to C data or None + :rtype: numpy.array or NoneType + """ + if dtype == LAMMPS_AUTODETECT: + dtype = self.lmp.extract_atom_datatype(name) + + if nelem == LAMMPS_AUTODETECT: + if name == "mass": + nelem = self.lmp.extract_global("ntypes") + 1 + else: + nelem = self.lmp.extract_global("nlocal") + if dim == LAMMPS_AUTODETECT: + if dtype in (LAMMPS_INT_2D, LAMMPS_DOUBLE_2D, LAMMPS_INT64_2D): + # TODO add other fields + if name in ("x", "v", "f", "x0","omega", "angmom", "torque", "csforce", "vforce", "vest"): + dim = 3 + elif name == "smd_data_9": + dim = 9 + elif name == "smd_stress": + dim = 6 + else: + dim = 2 + else: + dim = 1 + + raw_ptr = self.lmp.extract_atom(name, dtype) + + if dtype in (LAMMPS_DOUBLE, LAMMPS_DOUBLE_2D): + return self.darray(raw_ptr, nelem, dim) + elif dtype in (LAMMPS_INT, LAMMPS_INT_2D): + return self.iarray(c_int32, raw_ptr, nelem, dim) + elif dtype in (LAMMPS_INT64, LAMMPS_INT64_2D): + return self.iarray(c_int64, raw_ptr, nelem, dim) + return raw_ptr + + # ------------------------------------------------------------------------- + + def extract_atom_iarray(self, name, nelem, dim=1): + warnings.warn("deprecated, use extract_atom instead", DeprecationWarning) + + if name in ['id', 'molecule']: + c_int_type = self.lmp.c_tagint + elif name in ['image']: + c_int_type = self.lmp.c_imageint + else: + c_int_type = c_int + + if dim == 1: + raw_ptr = self.lmp.extract_atom(name, LAMMPS_INT) + else: + raw_ptr = self.lmp.extract_atom(name, LAMMPS_INT_2D) + + return self.iarray(c_int_type, raw_ptr, nelem, dim) + + # ------------------------------------------------------------------------- + + def extract_atom_darray(self, name, nelem, dim=1): + warnings.warn("deprecated, use extract_atom instead", DeprecationWarning) + + if dim == 1: + raw_ptr = self.lmp.extract_atom(name, LAMMPS_DOUBLE) + else: + raw_ptr = self.lmp.extract_atom(name, LAMMPS_DOUBLE_2D) + + return self.darray(raw_ptr, nelem, dim) + + # ------------------------------------------------------------------------- + + def extract_compute(self, cid, cstyle, ctype): + """Retrieve data from a LAMMPS compute + + This is a wrapper around the + :py:meth:`lammps.extract_compute() ` method. + It behaves the same as the original method, but returns NumPy arrays + instead of ``ctypes`` pointers. + + :param cid: compute ID + :type cid: string + :param cstyle: style of the data retrieve (global, atom, or local), see :ref:`py_style_constants` + :type cstyle: int + :param ctype: type of the returned data (scalar, vector, or array), see :ref:`py_type_constants` + :type ctype: int + :return: requested data either as float, as NumPy array with direct access to C data, or None + :rtype: float, numpy.array, or NoneType + """ + value = self.lmp.extract_compute(cid, cstyle, ctype) + + if cstyle == LMP_STYLE_GLOBAL: + if ctype == LMP_TYPE_VECTOR: + nrows = self.lmp.extract_compute(cid, cstyle, LMP_SIZE_VECTOR) + return self.darray(value, nrows) + elif ctype == LMP_TYPE_ARRAY: + nrows = self.lmp.extract_compute(cid, cstyle, LMP_SIZE_ROWS) + ncols = self.lmp.extract_compute(cid, cstyle, LMP_SIZE_COLS) + return self.darray(value, nrows, ncols) + elif cstyle == LMP_STYLE_LOCAL: + nrows = self.lmp.extract_compute(cid, cstyle, LMP_SIZE_ROWS) + ncols = self.lmp.extract_compute(cid, cstyle, LMP_SIZE_COLS) + if ncols == 0: + return self.darray(value, nrows) + else: + return self.darray(value, nrows, ncols) + elif cstyle == LMP_STYLE_ATOM: + if ctype == LMP_TYPE_VECTOR: + nlocal = self.lmp.extract_global("nlocal") + return self.darray(value, nlocal) + elif ctype == LMP_TYPE_ARRAY: + nlocal = self.lmp.extract_global("nlocal") + ncols = self.lmp.extract_compute(cid, cstyle, LMP_SIZE_COLS) + return self.darray(value, nlocal, ncols) + return value + + # ------------------------------------------------------------------------- + + def extract_fix(self, fid, fstyle, ftype, nrow=0, ncol=0): + """Retrieve data from a LAMMPS fix + + This is a wrapper around the :py:meth:`lammps.extract_fix() ` method. + It behaves the same as the original method, but returns NumPy arrays + instead of ``ctypes`` pointers. + + :param fid: fix ID + :type fid: string + :param fstyle: style of the data retrieve (global, atom, or local), see :ref:`py_style_constants` + :type fstyle: int + :param ftype: type or size of the returned data (scalar, vector, or array), see :ref:`py_type_constants` + :type ftype: int + :param nrow: index of global vector element or row index of global array element + :type nrow: int + :param ncol: column index of global array element + :type ncol: int + :return: requested data + :rtype: integer or double value, pointer to 1d or 2d double array or None + + """ + value = self.lmp.extract_fix(fid, fstyle, ftype, nrow, ncol) + if fstyle == LMP_STYLE_ATOM: + if ftype == LMP_TYPE_VECTOR: + nlocal = self.lmp.extract_global("nlocal") + return self.darray(value, nlocal) + elif ftype == LMP_TYPE_ARRAY: + nlocal = self.lmp.extract_global("nlocal") + ncols = self.lmp.extract_fix(fid, fstyle, LMP_SIZE_COLS, 0, 0) + return self.darray(value, nlocal, ncols) + elif fstyle == LMP_STYLE_LOCAL: + if ftype == LMP_TYPE_VECTOR: + nrows = self.lmp.extract_fix(fid, fstyle, LMP_SIZE_ROWS, 0, 0) + return self.darray(value, nrows) + elif ftype == LMP_TYPE_ARRAY: + nrows = self.lmp.extract_fix(fid, fstyle, LMP_SIZE_ROWS, 0, 0) + ncols = self.lmp.extract_fix(fid, fstyle, LMP_SIZE_COLS, 0, 0) + return self.darray(value, nrows, ncols) + return value + + # ------------------------------------------------------------------------- + + def extract_variable(self, name, group=None, vartype=LMP_VAR_EQUAL): + """ Evaluate a LAMMPS variable and return its data + + This function is a wrapper around the function + :py:meth:`lammps.extract_variable() ` + method. It behaves the same as the original method, but returns NumPy arrays + instead of ``ctypes`` pointers. + + :param name: name of the variable to execute + :type name: string + :param group: name of group for atom-style variable (ignored for equal-style variables) + :type group: string + :param vartype: type of variable, see :ref:`py_vartype_constants` + :type vartype: int + :return: the requested data or None + :rtype: c_double, numpy.array, or NoneType + """ + import numpy as np + value = self.lmp.extract_variable(name, group, vartype) + if vartype == LMP_VAR_ATOM: + return np.ctypeslib.as_array(value) + return value + + # ------------------------------------------------------------------------- + + def gather_bonds(self): + """Retrieve global list of bonds as NumPy array + + This is a wrapper around :py:meth:`lammps.gather_bonds() ` + It behaves the same as the original method, but returns a NumPy array instead + of a ``ctypes`` list. + + .. versionadded:: 28Jul2021 + + :return: the requested data as a 2d-integer numpy array + :rtype: numpy.array(nbonds,3) + """ + import numpy as np + nbonds, value = self.lmp.gather_bonds() + return np.ctypeslib.as_array(value).reshape(nbonds,3) + + # ------------------------------------------------------------------------- + + def fix_external_get_force(self, fix_id): + """Get access to the array with per-atom forces of a fix external instance with a given fix ID. + + This function is a wrapper around the + :py:meth:`lammps.fix_external_get_force() ` + method. It behaves the same as the original method, but returns a NumPy array instead + of a ``ctypes`` pointer. + + .. versionchanged:: 28Jul2021 + + :param fix_id: Fix-ID of a fix external instance + :type: string + :return: requested data + :rtype: numpy.array + """ + import numpy as np + nlocal = self.lmp.extract_setting('nlocal') + value = self.lmp.fix_external_get_force(fix_id) + return self.darray(value,nlocal,3) + + # ------------------------------------------------------------------------- + + def fix_external_set_energy_peratom(self, fix_id, eatom): + """Set the per-atom energy contribution for a fix external instance with the given ID. + + This function is an alternative to + :py:meth:`lammps.fix_external_set_energy_peratom() ` + method. It behaves the same as the original method, but accepts a NumPy array + instead of a list as argument. + + .. versionadded:: 28Jul2021 + + :param fix_id: Fix-ID of a fix external instance + :type: string + :param eatom: per-atom potential energy + :type: numpy.array + """ + import numpy as np + nlocal = self.lmp.extract_setting('nlocal') + if len(eatom) < nlocal: + raise Exception('per-atom energy dimension must be at least nlocal') + + c_double_p = POINTER(c_double) + value = eatom.astype(np.double) + return self.lmp.lib.lammps_fix_external_set_energy_peratom(self.lmp.lmp, fix_id.encode(), + value.ctypes.data_as(c_double_p)) + + # ------------------------------------------------------------------------- + + def fix_external_set_virial_peratom(self, fix_id, vatom): + """Set the per-atom virial contribution for a fix external instance with the given ID. + + This function is an alternative to + :py:meth:`lammps.fix_external_set_virial_peratom() ` + method. It behaves the same as the original method, but accepts a NumPy array + instead of a list as argument. + + .. versionadded:: 28Jul2021 + + :param fix_id: Fix-ID of a fix external instance + :type: string + :param eatom: per-atom potential energy + :type: numpy.array + """ + import numpy as np + nlocal = self.lmp.extract_setting('nlocal') + if len(vatom) < nlocal: + raise Exception('per-atom virial first dimension must be at least nlocal') + if len(vatom[0]) != 6: + raise Exception('per-atom virial second dimension must be 6') + + c_double_pp = np.ctypeslib.ndpointer(dtype=np.uintp, ndim=1, flags='C') + + # recast numpy array to be compatible with library interface + value = (vatom.__array_interface__['data'][0] + + np.arange(vatom.shape[0])*vatom.strides[0]).astype(np.uintp) + + # change prototype to our custom type + self.lmp.lib.lammps_fix_external_set_virial_peratom.argtypes = [ c_void_p, c_char_p, c_double_pp ] + + self.lmp.lib.lammps_fix_external_set_virial_peratom(self.lmp.lmp, fix_id.encode(), value) + + # ------------------------------------------------------------------------- + + def get_neighlist(self, idx): + """Returns an instance of :class:`NumPyNeighList` which wraps access to the neighbor list with the given index + + :param idx: index of neighbor list + :type idx: int + :return: an instance of :class:`NumPyNeighList` wrapping access to neighbor list data + :rtype: NumPyNeighList + """ + if idx < 0: + return None + return NumPyNeighList(self.lmp, idx) + + # ------------------------------------------------------------------------- + + def get_neighlist_element_neighbors(self, idx, element): + """Return data of neighbor list entry + + This function is a wrapper around the function + :py:meth:`lammps.get_neighlist_element_neighbors() ` + method. It behaves the same as the original method, but returns a NumPy array containing the neighbors + instead of a ``ctypes`` pointer. + + :param element: neighbor list index + :type element: int + :param element: neighbor list element index + :type element: int + :return: tuple with atom local index and numpy array of neighbor local atom indices + :rtype: (int, numpy.array) + """ + iatom, numneigh, c_neighbors = self.lmp.get_neighlist_element_neighbors(idx, element) + neighbors = self.iarray(c_int, c_neighbors, numneigh, 1) + return iatom, neighbors + + # ------------------------------------------------------------------------- + + def iarray(self, c_int_type, raw_ptr, nelem, dim=1): + if raw_ptr is None: + return None + + import numpy as np + np_int_type = self._ctype_to_numpy_int(c_int_type) + + if dim == 1: + ptr = cast(raw_ptr, POINTER(c_int_type * nelem)) + else: + ptr = cast(raw_ptr[0], POINTER(c_int_type * nelem * dim)) + + a = np.frombuffer(ptr.contents, dtype=np_int_type) + + if dim > 1: + a.shape = (nelem, dim) + else: + a.shape = (nelem) + return a + + # ------------------------------------------------------------------------- + + def darray(self, raw_ptr, nelem, dim=1): + if raw_ptr is None: + return None + + import numpy as np + + if dim == 1: + ptr = cast(raw_ptr, POINTER(c_double * nelem)) + else: + ptr = cast(raw_ptr[0], POINTER(c_double * nelem * dim)) + + a = np.frombuffer(ptr.contents) + + if dim > 1: + a.shape = (nelem, dim) + else: + a.shape = (nelem) + return a + +# ------------------------------------------------------------------------- + +class NumPyNeighList(NeighList): + """This is a wrapper class that exposes the contents of a neighbor list. + + It can be used like a regular Python list. Each element is a tuple of: + + * the atom local index + * a NumPy array containing the local atom indices of its neighbors + + Internally it uses the lower-level LAMMPS C-library interface. + + :param lmp: reference to instance of :py:class:`lammps` + :type lmp: lammps + :param idx: neighbor list index + :type idx: int + """ + def __init__(self, lmp, idx): + super(NumPyNeighList, self).__init__(lmp, idx) + + def get(self, element): + """ + Access a specific neighbor list entry. "element" must be a number from 0 to the size-1 of the list + + :return: tuple with atom local index, numpy array of neighbor local atom indices + :rtype: (int, numpy.array) + """ + iatom, neighbors = self.lmp.numpy.get_neighlist_element_neighbors(self.idx, element) + return iatom, neighbors + + def find(self, iatom): + """ + Find the neighbor list for a specific (local) atom iatom. + If there is no list for iatom, None is returned. + + :return: numpy array of neighbor local atom indices + :rtype: numpy.array or None + """ + inum = self.size + for ii in range(inum): + idx, neighbors = self.get(ii) + if idx == iatom: + return neighbors + return None diff --git a/python/lammps/pylammps.py b/python/lammps/pylammps.py new file mode 100644 index 0000000000..1fe1f2452b --- /dev/null +++ b/python/lammps/pylammps.py @@ -0,0 +1,990 @@ +# ---------------------------------------------------------------------- +# LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator +# https://www.lammps.org/ Sandia National Laboratories +# Steve Plimpton, sjplimp@sandia.gov +# +# Copyright (2003) Sandia Corporation. Under the terms of Contract +# DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains +# certain rights in this software. This software is distributed under +# the GNU General Public License. +# +# See the README file in the top-level LAMMPS directory. +# ------------------------------------------------------------------------- + +################################################################################ +# Alternative Python Wrapper +# Written by Richard Berger +################################################################################ + +# for python2/3 compatibility + +from __future__ import print_function + +import io +import os +import re +import sys +import tempfile +from collections import namedtuple + +from .core import lammps + +# ------------------------------------------------------------------------- + +class OutputCapture(object): + """ Utility class to capture LAMMPS library output """ + def __init__(self): + self.stdout_fd = 1 + self.captured_output = "" + + def __enter__(self): + self.tmpfile = tempfile.TemporaryFile(mode='w+b') + + sys.stdout.flush() + + # make copy of original stdout + self.stdout_orig = os.dup(self.stdout_fd) + + # replace stdout and redirect to temp file + os.dup2(self.tmpfile.fileno(), self.stdout_fd) + return self + + def __exit__(self, exc_type, exc_value, traceback): + os.dup2(self.stdout_orig, self.stdout_fd) + os.close(self.stdout_orig) + self.tmpfile.close() + + @property + def output(self): + sys.stdout.flush() + self.tmpfile.flush() + self.tmpfile.seek(0, io.SEEK_SET) + self.captured_output = self.tmpfile.read().decode('utf-8') + return self.captured_output + +# ------------------------------------------------------------------------- + +class Variable(object): + def __init__(self, pylammps_instance, name, style, definition): + self._pylmp = pylammps_instance + self.name = name + self.style = style + self.definition = definition.split() + + @property + def value(self): + if self.style == 'atom': + return list(self._pylmp.lmp.extract_variable(self.name, "all", 1)) + else: + value = self._pylmp.lmp_print('"${%s}"' % self.name).strip() + try: + return float(value) + except ValueError: + return value + +# ------------------------------------------------------------------------- + +class AtomList(object): + """ + A dynamic list of atoms that returns either an :py:class:`Atom` or + :py:class:`Atom2D` instance for each atom. Instances are only allocated + when accessed. + + :ivar natoms: total number of atoms + :ivar dimensions: number of dimensions in system + """ + def __init__(self, pylammps_instance): + self._pylmp = pylammps_instance + self.natoms = self._pylmp.system.natoms + self.dimensions = self._pylmp.system.dimensions + self._loaded = {} + + def __getitem__(self, index): + """ + Return Atom with given local index + + :param index: Local index of atom + :type index: int + :rtype: Atom or Atom2D + """ + if index not in self._loaded: + if self.dimensions == 2: + atom = Atom2D(self._pylmp, index) + else: + atom = Atom(self._pylmp, index) + self._loaded[index] = atom + return self._loaded[index] + + def __len__(self): + return self.natoms + + +# ------------------------------------------------------------------------- + +class Atom(object): + """ + A wrapper class then represents a single atom inside of LAMMPS + + It provides access to properties of the atom and allows you to change some of them. + """ + def __init__(self, pylammps_instance, index): + self._pylmp = pylammps_instance + self.index = index + + def __dir__(self): + return [k for k in super().__dir__() if not k.startswith('_')] + + def get(self, name, index): + prop = self._pylmp.lmp.numpy.extract_atom(name) + if prop is not None: + return prop[index] + return None + + @property + def id(self): + """ + Return the atom ID + + :type: int + """ + return self.get("id", self.index) + + @property + def type(self): + """ + Return the atom type + + :type: int + """ + return self.get("type", self.index) + + @property + def mol(self): + """ + Return the atom molecule index + + :type: int + """ + return self.get("mol", self.index) + + @property + def mass(self): + """ + Return the atom mass + + :type: float + """ + return self.get("mass", self.index) + + @property + def radius(self): + """ + Return the particle radius + + :type: float + """ + return self.get("radius", self.index) + + @property + def position(self): + """ + :getter: Return position of atom + :setter: Set position of atom + :type: numpy.array (float, float, float) + """ + return self.get("x", self.index) + + @position.setter + def position(self, value): + current = self.position + current[:] = value + + @property + def velocity(self): + """ + :getter: Return velocity of atom + :setter: Set velocity of atom + :type: numpy.array (float, float, float) + """ + return self.get("v", self.index) + + @velocity.setter + def velocity(self, value): + current = self.velocity + current[:] = value + + @property + def force(self): + """ + Return the total force acting on the atom + + :type: numpy.array (float, float, float) + """ + return self.get("f", self.index) + + @force.setter + def force(self, value): + current = self.force + current[:] = value + + @property + def torque(self): + """ + Return the total torque acting on the atom + + :type: numpy.array (float, float, float) + """ + return self.get("torque", self.index) + + @force.setter + def torque(self, value): + current = self.torque + current[:] = value + + @property + def omega(self): + """ + Return the rotational velocity of the particle + + :type: numpy.array (float, float, float) + """ + return self.get("torque", self.index) + + @omega.setter + def omega(self, value): + current = self.torque + current[:] = value + + @property + def torque(self): + """ + Return the total torque acting on the particle + + :type: numpy.array (float, float, float) + """ + return self.get("torque", self.index) + + @torque.setter + def torque(self, value): + current = self.torque + current[:] = value + + @property + def angular_momentum(self): + """ + Return the angular momentum of the particle + + :type: numpy.array (float, float, float) + """ + return self.get("angmom", self.index) + + @angular_momentum.setter + def angular_momentum(self, value): + current = self.angular_momentum + current[:] = value + + @property + def charge(self): + """ + Return the atom charge + + :type: float + """ + return self.get("q", self.index) + +# ------------------------------------------------------------------------- + +class Atom2D(Atom): + """ + A wrapper class then represents a single 2D atom inside of LAMMPS + + Inherits all properties from the :py:class:`Atom` class, but returns 2D versions + of position, velocity, and force. + + It provides access to properties of the atom and allows you to change some of them. + """ + def __init__(self, pylammps_instance, index): + super(Atom2D, self).__init__(pylammps_instance, index) + + @property + def position(self): + """Access to coordinates of an atom + + :getter: Return position of atom + :setter: Set position of atom + :type: numpy.array (float, float) + """ + return super(Atom2D, self).position[0:2] + + @position.setter + def position(self, value): + current = self.position + current[:] = value + + @property + def velocity(self): + """Access to velocity of an atom + :getter: Return velocity of atom + :setter: Set velocity of atom + :type: numpy.array (float, float) + """ + return super(Atom2D, self).velocity[0:2] + + @velocity.setter + def velocity(self, value): + current = self.velocity + current[:] = value + + @property + def force(self): + """Access to force of an atom + :getter: Return force of atom + :setter: Set force of atom + :type: numpy.array (float, float) + """ + return super(Atom2D, self).force[0:2] + + @force.setter + def force(self, value): + current = self.force + current[:] = value + +# ------------------------------------------------------------------------- + +class variable_set: + def __init__(self, name, variable_dict): + self._name = name + array_pattern = re.compile(r"(?P.+)\[(?P[0-9]+)\]") + + for key, value in variable_dict.items(): + m = array_pattern.match(key) + if m: + g = m.groupdict() + varname = g['arr'] + idx = int(g['index']) + if varname not in self.__dict__: + self.__dict__[varname] = {} + self.__dict__[varname][idx] = value + else: + self.__dict__[key] = value + + def __str__(self): + return "{}({})".format(self._name, ','.join(["{}={}".format(k, self.__dict__[k]) for k in self.__dict__.keys() if not k.startswith('_')])) + + def __dir__(self): + return [k for k in self.__dict__.keys() if not k.startswith('_')] + + def __repr__(self): + return self.__str__() + +# ------------------------------------------------------------------------- + +def get_thermo_data(output): + """ traverse output of runs and extract thermo data columns """ + if isinstance(output, str): + lines = output.splitlines() + else: + lines = output + + runs = [] + columns = [] + in_run = False + current_run = {} + + for line in lines: + if line.startswith("Per MPI rank memory allocation"): + in_run = True + elif in_run and len(columns) == 0: + # first line after memory usage are column names + columns = line.split() + + current_run = {} + + for col in columns: + current_run[col] = [] + + elif line.startswith("Loop time of "): + in_run = False + columns = [] + thermo_data = variable_set('ThermoData', current_run) + r = {'thermo' : thermo_data } + runs.append(namedtuple('Run', list(r.keys()))(*list(r.values()))) + elif in_run and len(columns) > 0: + items = line.split() + # Convert thermo output and store it. + # It must have the same number of columns and + # all of them must be convertible to floats. + # Otherwise we ignore the line + if len(items) == len(columns): + try: + values = [float(x) for x in items] + for i, col in enumerate(columns): + current_run[col].append(values[i]) + except ValueError: + # cannot convert. must be a non-thermo output. ignore. + pass + + return runs + +# ------------------------------------------------------------------------- +# ------------------------------------------------------------------------- + +class PyLammps(object): + """ + This is a Python wrapper class around the lower-level + :py:class:`lammps` class, exposing a more Python-like, + object-oriented interface for prototyping system inside of IPython and + Jupyter notebooks. + + It either creates its own instance of :py:class:`lammps` or can be + initialized with an existing instance. The arguments are the same of the + lower-level interface. The original interface can still be accessed via + :py:attr:`PyLammps.lmp`. + + :param name: "machine" name of the shared LAMMPS library ("mpi" loads ``liblammps_mpi.so``, "" loads ``liblammps.so``) + :type name: string + :param cmdargs: list of command line arguments to be passed to the :cpp:func:`lammps_open` function. The executable name is automatically added. + :type cmdargs: list + :param ptr: pointer to a LAMMPS C++ class instance when called from an embedded Python interpreter. None means load symbols from shared library. + :type ptr: pointer + :param comm: MPI communicator (as provided by `mpi4py `_). ``None`` means use ``MPI_COMM_WORLD`` implicitly. + :type comm: MPI_Comm + :param verbose: print all LAMMPS output to stdout + :type verbose: bool + + :ivar lmp: instance of original LAMMPS Python interface + :vartype lmp: :py:class:`lammps` + + :ivar runs: list of completed runs, each storing the thermo output + :vartype run: list + """ + + def __init__(self, name="", cmdargs=None, ptr=None, comm=None, verbose=False): + self.has_echo = False + self.verbose = verbose + + if cmdargs: + if '-echo' in cmdargs: + idx = cmdargs.index('-echo') + # ensures that echo line is ignored during output capture + self.has_echo = idx+1 < len(cmdargs) and cmdargs[idx+1] in ('screen', 'both') + + if ptr: + if isinstance(ptr,PyLammps): + self.lmp = ptr.lmp + elif isinstance(ptr,lammps): + self.lmp = ptr + else: + self.lmp = lammps(name=name,cmdargs=cmdargs,ptr=ptr,comm=comm) + else: + self.lmp = lammps(name=name,cmdargs=cmdargs,ptr=None,comm=comm) + print("LAMMPS output is captured by PyLammps wrapper") + self._cmd_history = [] + self._enable_cmd_history = False + self.runs = [] + + def __enter__(self): + return self + + def __exit__(self, ex_type, ex_value, ex_traceback): + self.close() + + def __del__(self): + if self.lmp: self.lmp.close() + self.lmp = None + + def close(self): + """Explicitly delete a LAMMPS instance + + This is a wrapper around the :py:meth:`lammps.close` of the Python interface. + """ + if self.lmp: self.lmp.close() + self.lmp = None + + def version(self): + """Return a numerical representation of the LAMMPS version in use. + + This is a wrapper around the :py:meth:`lammps.version` function of the Python interface. + + :return: version number + :rtype: int + """ + return self.lmp.version() + + def file(self, file): + """Read LAMMPS commands from a file. + + This is a wrapper around the :py:meth:`lammps.file` function of the Python interface. + + :param path: Name of the file/path with LAMMPS commands + :type path: string + """ + self.lmp.file(file) + + @property + def enable_cmd_history(self): + """ + :getter: Return whether command history is saved + :setter: Set if command history should be saved + :type: bool + """ + return self._enable_cmd_history + + @enable_cmd_history.setter + def enable_cmd_history(self, value): + """ + :getter: Return whether command history is saved + :setter: Set if command history should be saved + :type: bool + """ + self._enable_cmd_history = (value == True) + + def write_script(self, filepath): + """ + Write LAMMPS script file containing all commands executed up until now + + :param filepath: path to script file that should be written + :type filepath: string + """ + with open(filepath, "w") as f: + for cmd in self._cmd_history: + print(cmd, file=f) + + def clear_cmd_history(self): + """ + Clear LAMMPS command history up to this point + """ + self._cmd_history = [] + + def command(self, cmd): + """ + Execute LAMMPS command + + If :py:attr:`PyLammps.enable_cmd_history` is set to ``True``, commands executed + will be recorded. The entire command history can be written to a file using + :py:meth:`PyLammps.write_script()`. To clear the command history, use + :py:meth:`PyLammps.clear_cmd_history()`. + + :param cmd: command string that should be executed + :type: cmd: string + """ + self.lmp.command(cmd) + + if self.enable_cmd_history: + self._cmd_history.append(cmd) + + def run(self, *args, **kwargs): + """ + Execute LAMMPS run command with given arguments + + All thermo output during the run is captured and saved as new entry in + :py:attr:`PyLammps.runs`. The latest run can be retrieved by + :py:attr:`PyLammps.last_run`. + """ + output = self.__getattr__('run')(*args, **kwargs) + self.runs += get_thermo_data(output) + return output + + @property + def last_run(self): + """ + Return data produced of last completed run command + + :getter: Returns an object containing information about the last run command + :type: dict + """ + if len(self.runs) > 0: + return self.runs[-1] + return None + + @property + def atoms(self): + """ + All atoms of this LAMMPS instance + + :getter: Returns a list of atoms currently in the system + :type: AtomList + """ + return AtomList(self) + + @property + def system(self): + """ + The system state of this LAMMPS instance + + :getter: Returns an object with properties storing the current system state + :type: namedtuple + """ + output = self.lmp_info("system") + output = output[output.index("System information:")+1:] + d = self._parse_info_system(output) + return namedtuple('System', d.keys())(*d.values()) + + @property + def communication(self): + """ + The communication state of this LAMMPS instance + + :getter: Returns an object with properties storing the current communication state + :type: namedtuple + """ + output = self.lmp_info("communication") + output = output[output.index("Communication information:")+1:] + d = self._parse_info_communication(output) + return namedtuple('Communication', d.keys())(*d.values()) + + @property + def computes(self): + """ + The list of active computes of this LAMMPS instance + + :getter: Returns a list of computes that are currently active in this LAMMPS instance + :type: list + """ + output = self.lmp_info("computes") + output = output[output.index("Compute information:")+1:] + return self._parse_element_list(output) + + @property + def dumps(self): + """ + The list of active dumps of this LAMMPS instance + + :getter: Returns a list of dumps that are currently active in this LAMMPS instance + :type: list + """ + output = self.lmp_info("dumps") + output = output[output.index("Dump information:")+1:] + return self._parse_element_list(output) + + @property + def fixes(self): + """ + The list of active fixes of this LAMMPS instance + + :getter: Returns a list of fixes that are currently active in this LAMMPS instance + :type: list + """ + output = self.lmp_info("fixes") + output = output[output.index("Fix information:")+1:] + return self._parse_element_list(output) + + @property + def groups(self): + """ + The list of active atom groups of this LAMMPS instance + + :getter: Returns a list of atom groups that are currently active in this LAMMPS instance + :type: list + """ + output = self.lmp_info("groups") + output = output[output.index("Group information:")+1:] + return self._parse_groups(output) + + @property + def variables(self): + """ + Returns a dictionary of all variables defined in the current LAMMPS instance + + :getter: Returns a dictionary of all variables that are defined in this LAMMPS instance + :type: dict + """ + output = self.lmp_info("variables") + output = output[output.index("Variable information:")+1:] + variables = {} + for v in self._parse_element_list(output): + variables[v['name']] = Variable(self, v['name'], v['style'], v['def']) + return variables + + def eval(self, expr): + """ + Evaluate expression + + :param expr: the expression string that should be evaluated inside of LAMMPS + :type expr: string + + :return: the value of the evaluated expression + :rtype: float if numeric, string otherwise + """ + value = self.lmp_print('"$(%s)"' % expr).strip() + try: + return float(value) + except ValueError: + return value + + def _split_values(self, line): + return [x.strip() for x in line.split(',')] + + def _get_pair(self, value): + return [x.strip() for x in value.split('=')] + + def _parse_info_system(self, output): + system = {} + + for line in output: + if line.startswith("Units"): + system['units'] = self._get_pair(line)[1] + elif line.startswith("Atom style"): + system['atom_style'] = self._get_pair(line)[1] + elif line.startswith("Atom map"): + system['atom_map'] = self._get_pair(line)[1] + elif line.startswith("Atoms"): + parts = self._split_values(line) + system['natoms'] = int(self._get_pair(parts[0])[1]) + system['ntypes'] = int(self._get_pair(parts[1])[1]) + system['style'] = self._get_pair(parts[2])[1] + elif line.startswith("Kspace style"): + system['kspace_style'] = self._get_pair(line)[1] + elif line.startswith("Dimensions"): + system['dimensions'] = int(self._get_pair(line)[1]) + elif line.startswith("Orthogonal box"): + system['orthogonal_box'] = [float(x) for x in self._get_pair(line)[1].split('x')] + elif line.startswith("Boundaries"): + system['boundaries'] = self._get_pair(line)[1] + elif line.startswith("xlo"): + keys, values = [self._split_values(x) for x in self._get_pair(line)] + for key, value in zip(keys, values): + system[key] = float(value) + elif line.startswith("ylo"): + keys, values = [self._split_values(x) for x in self._get_pair(line)] + for key, value in zip(keys, values): + system[key] = float(value) + elif line.startswith("zlo"): + keys, values = [self._split_values(x) for x in self._get_pair(line)] + for key, value in zip(keys, values): + system[key] = float(value) + elif line.startswith("Molecule type"): + system['molecule_type'] = self._get_pair(line)[1] + elif line.startswith("Bonds"): + parts = self._split_values(line) + system['nbonds'] = int(self._get_pair(parts[0])[1]) + system['nbondtypes'] = int(self._get_pair(parts[1])[1]) + system['bond_style'] = self._get_pair(parts[2])[1] + elif line.startswith("Angles"): + parts = self._split_values(line) + system['nangles'] = int(self._get_pair(parts[0])[1]) + system['nangletypes'] = int(self._get_pair(parts[1])[1]) + system['angle_style'] = self._get_pair(parts[2])[1] + elif line.startswith("Dihedrals"): + parts = self._split_values(line) + system['ndihedrals'] = int(self._get_pair(parts[0])[1]) + system['ndihedraltypes'] = int(self._get_pair(parts[1])[1]) + system['dihedral_style'] = self._get_pair(parts[2])[1] + elif line.startswith("Impropers"): + parts = self._split_values(line) + system['nimpropers'] = int(self._get_pair(parts[0])[1]) + system['nimpropertypes'] = int(self._get_pair(parts[1])[1]) + system['improper_style'] = self._get_pair(parts[2])[1] + + return system + + def _parse_info_communication(self, output): + comm = {} + + for line in output: + if line.startswith("MPI library"): + comm['mpi_version'] = line.split(':')[1].strip() + elif line.startswith("Comm style"): + parts = self._split_values(line) + comm['comm_style'] = self._get_pair(parts[0])[1] + comm['comm_layout'] = self._get_pair(parts[1])[1] + elif line.startswith("Processor grid"): + comm['proc_grid'] = [int(x) for x in self._get_pair(line)[1].split('x')] + elif line.startswith("Communicate velocities for ghost atoms"): + comm['ghost_velocity'] = (self._get_pair(line)[1] == "yes") + elif line.startswith("Nprocs"): + parts = self._split_values(line) + comm['nprocs'] = int(self._get_pair(parts[0])[1]) + comm['nthreads'] = int(self._get_pair(parts[1])[1]) + return comm + + def _parse_element_list(self, output): + elements = [] + + for line in output: + if not line or (":" not in line): continue + element_info = self._split_values(line.split(':')[1].strip()) + element = {'name': element_info[0]} + for key, value in [self._get_pair(x) for x in element_info[1:]]: + element[key] = value + elements.append(element) + return elements + + def _parse_groups(self, output): + groups = [] + group_pattern = re.compile(r"(?P.+) \((?P.+)\)") + + for line in output: + m = group_pattern.match(line.split(':')[1].strip()) + group = {'name': m.group('name'), 'type': m.group('type')} + groups.append(group) + return groups + + def lmp_print(self, s): + """ needed for Python2 compatibility, since print is a reserved keyword """ + return self.__getattr__("print")(s) + + def __dir__(self): + return sorted(set(['angle_coeff', 'angle_style', 'atom_modify', 'atom_style', 'atom_style', + 'bond_coeff', 'bond_style', 'boundary', 'change_box', 'communicate', 'compute', + 'create_atoms', 'create_box', 'delete_atoms', 'delete_bonds', 'dielectric', + 'dihedral_coeff', 'dihedral_style', 'dimension', 'dump', 'fix', 'fix_modify', + 'group', 'improper_coeff', 'improper_style', 'include', 'kspace_modify', + 'kspace_style', 'lattice', 'mass', 'minimize', 'min_style', 'neighbor', + 'neigh_modify', 'newton', 'nthreads', 'pair_coeff', 'pair_modify', + 'pair_style', 'processors', 'read', 'read_data', 'read_restart', 'region', + 'replicate', 'reset_timestep', 'restart', 'run', 'run_style', 'thermo', + 'thermo_modify', 'thermo_style', 'timestep', 'undump', 'unfix', 'units', + 'variable', 'velocity', 'write_restart'] + self.lmp.available_styles("command"))) + + def lmp_info(self, s): + # skip anything before and after Info-Info-Info + # also skip timestamp line + output = self.__getattr__("info")(s) + indices = [index for index, line in enumerate(output) if line.startswith("Info-Info-Info-Info")] + start = indices[0] + end = indices[1] + return [line for line in output[start+2:end] if line] + + def __getattr__(self, name): + """ + This method is where the Python 'magic' happens. If a method is not + defined by the class PyLammps, it assumes it is a LAMMPS command. It takes + all the arguments, concatinates them to a single string, and executes it using + :py:meth:`lammps.PyLammps.command()`. + + :param verbose: Print output of command + :type verbose: bool + :return: line or list of lines of output, None if no output + :rtype: list or string + """ + def handler(*args, **kwargs): + cmd_args = [name] + [str(x) for x in args] + self.lmp.flush_buffers() + + with OutputCapture() as capture: + cmd = ' '.join(cmd_args) + self.command(cmd) + self.lmp.flush_buffers() + output = capture.output + + comm = self.lmp.get_mpi_comm() + if comm: + output = self.lmp.comm.bcast(output, root=0) + + if self.verbose or ('verbose' in kwargs and kwargs['verbose']): + print(output, end = '') + + lines = output.splitlines() + + if self.has_echo: + lines = lines[1:] + + if len(lines) > 1: + return lines + elif len(lines) == 1: + return lines[0] + return None + + return handler + + +class IPyLammps(PyLammps): + """ + IPython wrapper for LAMMPS which adds embedded graphics capabilities to PyLammmps interface + + It either creates its own instance of :py:class:`lammps` or can be + initialized with an existing instance. The arguments are the same of the + lower-level interface. The original interface can still be accessed via + :py:attr:`PyLammps.lmp`. + + :param name: "machine" name of the shared LAMMPS library ("mpi" loads ``liblammps_mpi.so``, "" loads ``liblammps.so``) + :type name: string + :param cmdargs: list of command line arguments to be passed to the :cpp:func:`lammps_open` function. The executable name is automatically added. + :type cmdargs: list + :param ptr: pointer to a LAMMPS C++ class instance when called from an embedded Python interpreter. None means load symbols from shared library. + :type ptr: pointer + :param comm: MPI communicator (as provided by `mpi4py `_). ``None`` means use ``MPI_COMM_WORLD`` implicitly. + :type comm: MPI_Comm + """ + + def __init__(self,name="",cmdargs=None,ptr=None,comm=None): + super(IPyLammps, self).__init__(name=name,cmdargs=cmdargs,ptr=ptr,comm=comm) + + def image(self, filename="snapshot.png", group="all", color="type", diameter="type", + size=None, view=None, center=None, up=None, zoom=1.0, background_color="white"): + """ Generate image using write_dump command and display it + + See :doc:`dump image ` for more information. + + :param filename: Name of the image file that should be generated. The extension determines whether it is PNG or JPEG + :type filename: string + :param group: the group of atoms write_image should use + :type group: string + :param color: name of property used to determine color + :type color: string + :param diameter: name of property used to determine atom diameter + :type diameter: string + :param size: dimensions of image + :type size: tuple (width, height) + :param view: view parameters + :type view: tuple (theta, phi) + :param center: center parameters + :type center: tuple (flag, center_x, center_y, center_z) + :param up: vector pointing to up direction + :type up: tuple (up_x, up_y, up_z) + :param zoom: zoom factor + :type zoom: float + :param background_color: background color of scene + :type background_color: string + + :return: Image instance used to display image in notebook + :rtype: :py:class:`IPython.core.display.Image` + """ + cmd_args = [group, "image", filename, color, diameter] + + if size is not None: + width = size[0] + height = size[1] + cmd_args += ["size", width, height] + + if view is not None: + theta = view[0] + phi = view[1] + cmd_args += ["view", theta, phi] + + if center is not None: + flag = center[0] + Cx = center[1] + Cy = center[2] + Cz = center[3] + cmd_args += ["center", flag, Cx, Cy, Cz] + + if up is not None: + Ux = up[0] + Uy = up[1] + Uz = up[2] + cmd_args += ["up", Ux, Uy, Uz] + + if zoom is not None: + cmd_args += ["zoom", zoom] + + cmd_args.append("modify backcolor " + background_color) + + self.write_dump(*cmd_args) + from IPython.core.display import Image + return Image(filename) + + def video(self, filename): + """ + Load video from file + + Can be used to visualize videos from :doc:`dump movie `. + + :param filename: Path to video file + :type filename: string + :return: HTML Video Tag used by notebook to embed a video + :rtype: :py:class:`IPython.display.HTML` + """ + from IPython.display import HTML + return HTML("") From de12ea976222872e657fd11aac60c3b3e8bf0734 Mon Sep 17 00:00:00 2001 From: rohskopf Date: Thu, 7 Jul 2022 17:21:19 -0600 Subject: [PATCH 556/585] Clean up --- lammps | 1 - 1 file changed, 1 deletion(-) delete mode 120000 lammps diff --git a/lammps b/lammps deleted file mode 120000 index 6ce10c039d..0000000000 --- a/lammps +++ /dev/null @@ -1 +0,0 @@ -python/lammps/ \ No newline at end of file From 9e93eda19a29e8b78d91281b6ecc989addf30b55 Mon Sep 17 00:00:00 2001 From: rohskopf Date: Thu, 7 Jul 2022 17:23:58 -0600 Subject: [PATCH 557/585] Format --- src/ML-SNAP/compute_snap.h | 1 - src/ML-SNAP/sna.cpp | 1 - 2 files changed, 2 deletions(-) diff --git a/src/ML-SNAP/compute_snap.h b/src/ML-SNAP/compute_snap.h index 4ef714190c..0a9af58519 100644 --- a/src/ML-SNAP/compute_snap.h +++ b/src/ML-SNAP/compute_snap.h @@ -58,7 +58,6 @@ class ComputeSnap : public Compute { Compute *c_virial; void dbdotr_compute(); - }; } // namespace LAMMPS_NS diff --git a/src/ML-SNAP/sna.cpp b/src/ML-SNAP/sna.cpp index 30ae30ae4f..123c16e2ac 100644 --- a/src/ML-SNAP/sna.cpp +++ b/src/ML-SNAP/sna.cpp @@ -1334,7 +1334,6 @@ double SNA::memory_usage() void SNA::create_twojmax_arrays() { - int jdimpq = twojmax + 2; memory->create(rootpqarray, jdimpq, jdimpq, "sna:rootpqarray"); From d6426d5e42b2a91cbaa519a61c4a3ccfa226a5a5 Mon Sep 17 00:00:00 2001 From: Stan Gerald Moore Date: Fri, 8 Jul 2022 09:50:19 -0600 Subject: [PATCH 558/585] Small tweak --- src/pair_hybrid.cpp | 25 ++++++++++--------------- src/pair_hybrid.h | 1 - 2 files changed, 10 insertions(+), 16 deletions(-) diff --git a/src/pair_hybrid.cpp b/src/pair_hybrid.cpp index 3af497ca15..368e6d938b 100644 --- a/src/pair_hybrid.cpp +++ b/src/pair_hybrid.cpp @@ -41,7 +41,6 @@ PairHybrid::PairHybrid(LAMMPS *lmp) : Pair(lmp), outerflag = 0; respaflag = 0; - style_cutoff_flag = 1; } /* ---------------------------------------------------------------------- */ @@ -57,8 +56,7 @@ PairHybrid::~PairHybrid() } } delete[] styles; - if (style_cutoff_flag) - delete[] cutmax_style; + delete[] cutmax_style; delete[] keywords; delete[] multiple; @@ -301,10 +299,8 @@ void PairHybrid::settings(int narg, char **arg) // allocate list of sub-styles as big as possibly needed if no extra args styles = new Pair *[narg]; - if (style_cutoff_flag) { - cutmax_style = new double[narg]; - memset(cutmax_style, 0.0, narg*sizeof(double)); - } + cutmax_style = new double[narg]; + memset(cutmax_style, 0.0, narg*sizeof(double)); keywords = new char *[narg]; multiple = new int[narg]; @@ -724,10 +720,11 @@ double PairHybrid::init_one(int i, int j) } cutmax = MAX(cutmax,cut); - if (style_cutoff_flag) { - int istyle; - for (istyle = 0; istyle < nstyles; istyle++) - if (styles[istyle] == styles[map[i][j][k]]) break; + int istyle; + for (istyle = 0; istyle < nstyles; istyle++) + if (styles[istyle] == styles[map[i][j][k]]) break; + + if (styles[istyle]->trim_flag) { if (cut > cutmax_style[istyle]) { cutmax_style[istyle] = cut; @@ -802,10 +799,8 @@ void PairHybrid::read_restart(FILE *fp) delete[] compute_tally; styles = new Pair*[nstyles]; - if (style_cutoff_flag) { - cutmax_style = new double[nstyles]; - memset(cutmax_style, 0.0, nstyles*sizeof(double)); - } + cutmax_style = new double[nstyles]; + memset(cutmax_style, 0.0, nstyles*sizeof(double)); keywords = new char*[nstyles]; multiple = new int[nstyles]; diff --git a/src/pair_hybrid.h b/src/pair_hybrid.h index 97bb01d8e7..4247354d5e 100644 --- a/src/pair_hybrid.h +++ b/src/pair_hybrid.h @@ -70,7 +70,6 @@ class PairHybrid : public Pair { protected: int nstyles; // # of sub-styles Pair **styles; // list of Pair style classes - int style_cutoff_flag; // 1 if build a separate neigh list for each style double *cutmax_style; // max cutoff for each style char **keywords; // style name of each Pair style int *multiple; // 0 if style used once, else Mth instance From 31d88618c6ec18d1eeb58227feef4481e0f7b7e4 Mon Sep 17 00:00:00 2001 From: Stan Gerald Moore Date: Fri, 8 Jul 2022 09:58:42 -0600 Subject: [PATCH 559/585] Initialize variable --- src/pair.cpp | 1 + 1 file changed, 1 insertion(+) diff --git a/src/pair.cpp b/src/pair.cpp index d41e7b706c..ff56cf4967 100644 --- a/src/pair.cpp +++ b/src/pair.cpp @@ -97,6 +97,7 @@ Pair::Pair(LAMMPS *lmp) : Pointers(lmp) tabinner_disp = sqrt(2.0); ftable = nullptr; fdisptable = nullptr; + trim_flag = 0; allocated = 0; suffix_flag = Suffix::NONE; From ba2999dfbbc2213b041e64ae8da28c57b445ed46 Mon Sep 17 00:00:00 2001 From: Stan Gerald Moore Date: Fri, 8 Jul 2022 10:04:33 -0600 Subject: [PATCH 560/585] Whitespace --- src/neighbor.cpp | 2 +- src/npair_halffull_newton_trim.cpp | 2 +- 2 files changed, 2 insertions(+), 2 deletions(-) diff --git a/src/neighbor.cpp b/src/neighbor.cpp index d5b4915f82..1a790169e3 100644 --- a/src/neighbor.cpp +++ b/src/neighbor.cpp @@ -1162,7 +1162,7 @@ void Neighbor::morph_unique() } else { irq->cut = 0; irq->cutoff = 0.0; - } + } } // avoid flagging a neighbor list as both INTEL and OPENMP diff --git a/src/npair_halffull_newton_trim.cpp b/src/npair_halffull_newton_trim.cpp index 89a28e81ae..26e46a0525 100644 --- a/src/npair_halffull_newton_trim.cpp +++ b/src/npair_halffull_newton_trim.cpp @@ -91,7 +91,7 @@ void NPairHalffullNewtonTrim::build(NeighList *list) delz = ztmp - x[j][2]; rsq = delx * delx + dely * dely + delz * delz; - if (rsq > cutsq_custom) continue; + if (rsq > cutsq_custom) continue; neighptr[n++] = joriginal; } From 45a02e52395d7c5b9c2aa25f58e1d579acd82dca Mon Sep 17 00:00:00 2001 From: rohskopf Date: Fri, 8 Jul 2022 13:07:49 -0600 Subject: [PATCH 561/585] Cosmetic changes --- src/ML-SNAP/compute_snap.cpp | 26 +++++++++----------------- 1 file changed, 9 insertions(+), 17 deletions(-) diff --git a/src/ML-SNAP/compute_snap.cpp b/src/ML-SNAP/compute_snap.cpp index 3200ecd756..15a2c6ebed 100644 --- a/src/ML-SNAP/compute_snap.cpp +++ b/src/ML-SNAP/compute_snap.cpp @@ -13,6 +13,7 @@ ------------------------------------------------------------------------- */ #include "compute_snap.h" + #include "sna.h" #include "atom.h" #include "update.h" @@ -145,12 +146,12 @@ ComputeSnap::ComputeSnap(LAMMPS *lmp, int narg, char **arg) : } else if (strcmp(arg[iarg],"dgradflag") == 0) { if (iarg+2 > narg) error->all(FLERR,"Illegal compute snap command"); - dgradflag = atoi(arg[iarg+1]); + dgradflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg],"switchinnerflag") == 0) { if (iarg+2 > narg) error->all(FLERR,"Illegal compute snap command"); - switchinnerflag = atoi(arg[iarg+1]); + switchinnerflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "sinner") == 0) { iarg++; @@ -228,7 +229,6 @@ ComputeSnap::ComputeSnap(LAMMPS *lmp, int narg, char **arg) : ComputeSnap::~ComputeSnap() { - memory->destroy(snap); memory->destroy(snapall); memory->destroy(snap_peratom); @@ -252,9 +252,8 @@ void ComputeSnap::init() if (force->pair == nullptr) error->all(FLERR,"Compute snap requires a pair style be defined"); - if (cutmax > force->pair->cutforce){ + if (cutmax > force->pair->cutforce) error->all(FLERR,"Compute snap cutoff is longer than pairwise cutoff"); - } // need an occasional full neighbor list @@ -321,17 +320,15 @@ void ComputeSnap::compute_array() // clear global array - for (int irow = 0; irow < size_array_rows; irow++){ - for (int icoeff = 0; icoeff < size_array_cols; icoeff++){ + for (int irow = 0; irow < size_array_rows; irow++) + for (int icoeff = 0; icoeff < size_array_cols; icoeff++) snap[irow][icoeff] = 0.0; - } - } // clear local peratom array + for (int i = 0; i < ntotal; i++) - for (int icoeff = 0; icoeff < size_peratom; icoeff++) { + for (int icoeff = 0; icoeff < size_peratom; icoeff++) snap_peratom[i][icoeff] = 0.0; - } // invoke full neighbor list (will copy or build if necessary) @@ -537,7 +534,6 @@ void ComputeSnap::compute_array() snap[bik_rows + ((atom->tag[i]-1)*3*natoms) + 3*(atom->tag[i]-1) + 2][icoeff+3] += snaptr->dblist[icoeff][2]; } } - } // loop over jj inside // accumulate Bi @@ -569,9 +565,7 @@ void ComputeSnap::compute_array() snap[irow][k++] += snaptr->blist[icoeff]; numneigh_sum += ninside; } - - } // if (mask[i] & groupbit) - + } } // for (int ii = 0; ii < inum; ii++) { // accumulate bispectrum force contributions to global array @@ -604,7 +598,6 @@ void ComputeSnap::compute_array() snap[irow++][lastcol] = atom->f[i][1]; snap[irow][lastcol] = atom->f[i][2]; } - } else { // for dgradflag=1, put forces at first 3 columns of bik rows @@ -632,7 +625,6 @@ void ComputeSnap::compute_array() int irow = 0; double reference_energy = c_pe->compute_scalar(); snapall[irow][lastcol] = reference_energy; - } else { // assign reference energy right after the dgrad rows, first column From e7f11a82ac6a63eb3ff953056acaf5d7868cd18c Mon Sep 17 00:00:00 2001 From: rohskopf Date: Fri, 8 Jul 2022 13:24:26 -0600 Subject: [PATCH 562/585] More cosmetic changes --- src/ML-SNAP/compute_snap.cpp | 13 ++++--------- 1 file changed, 4 insertions(+), 9 deletions(-) diff --git a/src/ML-SNAP/compute_snap.cpp b/src/ML-SNAP/compute_snap.cpp index 15a2c6ebed..86edcf99fe 100644 --- a/src/ML-SNAP/compute_snap.cpp +++ b/src/ML-SNAP/compute_snap.cpp @@ -205,7 +205,7 @@ ComputeSnap::ComputeSnap(LAMMPS *lmp, int narg, char **arg) : ndims_force = 3; ndims_virial = 6; yoffset = nvalues; - zoffset = 2 * nvalues; + zoffset = 2*nvalues; natoms = atom->natoms; bik_rows = 1; if (bikflag) bik_rows = natoms; @@ -236,13 +236,13 @@ ComputeSnap::~ComputeSnap() memory->destroy(wjelem); memory->destroy(cutsq); delete snaptr; + if (chemflag) memory->destroy(map); if (switchinnerflag) { memory->destroy(sinnerelem); memory->destroy(dinnerelem); } - } /* ---------------------------------------------------------------------- */ @@ -304,7 +304,6 @@ void ComputeSnap::init_list(int /*id*/, NeighList *ptr) void ComputeSnap::compute_array() { - int ntotal = atom->nlocal + atom->nghost; invoked_array = update->ntimestep; @@ -345,9 +344,7 @@ void ComputeSnap::compute_array() double** const x = atom->x; const int* const mask = atom->mask; - int ninside; - int numneigh_sum = 0; - int dgrad_row_indx; + for (int ii = 0; ii < inum; ii++) { int irow = 0; if (bikflag) irow = atom->tag[ilist[ii] & NEIGHMASK]-1; @@ -407,7 +404,7 @@ void ComputeSnap::compute_array() // assign quantities in snaptr - ninside=0; + int ninside=0; for (int jj = 0; jj < jnum; jj++) { int j = jlist[jj]; j &= NEIGHMASK; @@ -563,7 +560,6 @@ void ComputeSnap::compute_array() int k = 3; for (int icoeff = 0; icoeff < ncoeff; icoeff++) snap[irow][k++] += snaptr->blist[icoeff]; - numneigh_sum += ninside; } } } // for (int ii = 0; ii < inum; ii++) { @@ -571,7 +567,6 @@ void ComputeSnap::compute_array() // accumulate bispectrum force contributions to global array if (!dgradflag) { - for (int itype = 0; itype < atom->ntypes; itype++) { const int typeoffset_local = ndims_peratom*nvalues*itype; const int typeoffset_global = nvalues*itype; From b4424e77b11fa2f1240cbd303937184b38a43350 Mon Sep 17 00:00:00 2001 From: rohskopf Date: Fri, 8 Jul 2022 13:32:51 -0600 Subject: [PATCH 563/585] More cosmetic changes 2 --- src/ML-SNAP/compute_snap.cpp | 12 ++++-------- 1 file changed, 4 insertions(+), 8 deletions(-) diff --git a/src/ML-SNAP/compute_snap.cpp b/src/ML-SNAP/compute_snap.cpp index 86edcf99fe..7865829a01 100644 --- a/src/ML-SNAP/compute_snap.cpp +++ b/src/ML-SNAP/compute_snap.cpp @@ -144,13 +144,11 @@ ComputeSnap::ComputeSnap(LAMMPS *lmp, int narg, char **arg) : bikflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg],"dgradflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute snap command"); + if (iarg + 2 > narg) error->all(FLERR,"Illegal compute snap command"); dgradflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg],"switchinnerflag") == 0) { - if (iarg+2 > narg) - error->all(FLERR,"Illegal compute snap command"); + if (iarg + 2 > narg) error->all(FLERR,"Illegal compute snap command"); switchinnerflag = utils::inumeric(FLERR, arg[iarg + 1], false, lmp); iarg += 2; } else if (strcmp(arg[iarg], "sinner") == 0) { @@ -191,10 +189,8 @@ ComputeSnap::ComputeSnap(LAMMPS *lmp, int narg, char **arg) : if (dgradflag && quadraticflag) error->all(FLERR,"Illegal compute snap command: dgradflag=1 not implemented for quadratic SNAP"); - snaptr = new SNA(lmp, rfac0, twojmax, - rmin0, switchflag, bzeroflag, - chemflag, bnormflag, wselfallflag, - nelements, switchinnerflag); + snaptr = new SNA(lmp, rfac0, twojmax, rmin0, switchflag, bzeroflag, chemflag, bnormflag, + wselfallflag, nelements, switchinnerflag); ncoeff = snaptr->ncoeff; nvalues = ncoeff; From 9f309d56fef96b1ba47f44da106e87828c9be80b Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sat, 9 Jul 2022 16:06:21 -0400 Subject: [PATCH 564/585] a few more programming style changes --- src/ML-SNAP/compute_snap.cpp | 24 ++++++++++++------------ 1 file changed, 12 insertions(+), 12 deletions(-) diff --git a/src/ML-SNAP/compute_snap.cpp b/src/ML-SNAP/compute_snap.cpp index 7865829a01..5d2f3666bc 100644 --- a/src/ML-SNAP/compute_snap.cpp +++ b/src/ML-SNAP/compute_snap.cpp @@ -14,17 +14,17 @@ #include "compute_snap.h" -#include "sna.h" #include "atom.h" -#include "update.h" -#include "modify.h" -#include "neighbor.h" -#include "neigh_list.h" -#include "force.h" -#include "pair.h" #include "comm.h" -#include "memory.h" #include "error.h" +#include "force.h" +#include "memory.h" +#include "modify.h" +#include "neigh_list.h" +#include "neighbor.h" +#include "pair.h" +#include "sna.h" +#include "update.h" #include @@ -207,7 +207,7 @@ ComputeSnap::ComputeSnap(LAMMPS *lmp, int narg, char **arg) : if (bikflag) bik_rows = natoms; dgrad_rows = ndims_force*natoms; size_array_rows = bik_rows+dgrad_rows + ndims_virial; - if (dgradflag){ + if (dgradflag) { size_array_rows = bik_rows + 3*natoms*natoms + 1; size_array_cols = nvalues + 3; error->warning(FLERR,"dgradflag=1 creates a N^2 array, beware of large systems."); @@ -360,7 +360,7 @@ void ComputeSnap::compute_array() const int typeoffset_local = ndims_peratom*nvalues*(itype-1); const int typeoffset_global = nvalues*(itype-1); - if (dgradflag){ + if (dgradflag) { // dBi/dRi tags @@ -376,7 +376,7 @@ void ComputeSnap::compute_array() // dBi/dRj tags - for (int j=0; jtag[i]-1) + 0][0] = atom->tag[i]-1; snap[bik_rows + ((j)*3*natoms) + 3*(atom->tag[i]-1) + 0][1] = j; snap[bik_rows + ((j)*3*natoms) + 3*(atom->tag[i]-1) + 0][2] = 0; @@ -593,7 +593,7 @@ void ComputeSnap::compute_array() // for dgradflag=1, put forces at first 3 columns of bik rows - for (int i=0; inlocal; i++){ + for (int i=0; inlocal; i++) { int iglobal = atom->tag[i]; snap[iglobal-1][0+0] = atom->f[i][0]; snap[iglobal-1][0+1] = atom->f[i][1]; From ee8fa353556a3ea35ba8e85970dbf2feab56cb01 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sat, 9 Jul 2022 16:07:55 -0400 Subject: [PATCH 565/585] fix typo --- doc/src/compute_sna_atom.rst | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/doc/src/compute_sna_atom.rst b/doc/src/compute_sna_atom.rst index 5efecd6738..1b6b200685 100644 --- a/doc/src/compute_sna_atom.rst +++ b/doc/src/compute_sna_atom.rst @@ -536,7 +536,7 @@ columns corresponding to the type of that atom. This is not true in the case of *dgradflag* keyword = 1 (see below). If the *dgradflag* keyword is set to 1, this changes the structure of the -gloabl array completely. +global array completely. Here the *snad/atom* quantities are replaced with rows corresponding to descriptor gradient components on single atoms: From bf6ad1bb453a36791ca9844f9f36386faa97fbeb Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sun, 10 Jul 2022 05:00:03 -0400 Subject: [PATCH 566/585] add option to read_dump that prevents resetting the timestep --- doc/src/dump.rst | 5 +++++ doc/src/read_dump.rst | 35 +++++++++++++++++++---------------- src/read_dump.cpp | 7 ++++++- src/read_dump.h | 3 ++- 4 files changed, 32 insertions(+), 18 deletions(-) diff --git a/doc/src/dump.rst b/doc/src/dump.rst index 4417e186ec..843d2e4883 100644 --- a/doc/src/dump.rst +++ b/doc/src/dump.rst @@ -783,6 +783,11 @@ To write gzipped dump files, you must either compile LAMMPS with the -DLAMMPS_GZIP option or use the styles from the COMPRESS package. See the :doc:`Build settings ` page for details. +While a dump command is active (i.e. has not been stopped by using +the undump command), no commands may be used that will change the +timestep (e.g. :doc:`reset_timestep `). LAMMPS +will terminate with an error otherwise. + The *atom/gz*, *cfg/gz*, *custom/gz*, and *xyz/gz* styles are part of the COMPRESS package. They are only enabled if LAMMPS was built with that package. See the :doc:`Build package ` page for diff --git a/doc/src/read_dump.rst b/doc/src/read_dump.rst index 3a771b9c2d..c98347914b 100644 --- a/doc/src/read_dump.rst +++ b/doc/src/read_dump.rst @@ -24,12 +24,13 @@ Syntax *fx*,\ *fy*,\ *fz* = force components * zero or more keyword/value pairs may be appended -* keyword = *nfile* or *box* or *replace* or *purge* or *trim* or *add* or *label* or *scaled* or *wrapped* or *format* +* keyword = *nfile* or *box* or *timestep* or *replace* or *purge* or *trim* or *add* or *label* or *scaled* or *wrapped* or *format* .. parsed-literal:: *nfile* value = Nfiles = how many parallel dump files exist *box* value = *yes* or *no* = replace simulation box with dump box + *timestep* value = *yes* or *no* = reset simulation timestep with dump timestep *replace* value = *yes* or *no* = overwrite atoms with dump atoms *purge* value = *yes* or *no* = delete all atoms before adding dump atoms *trim* value = *yes* or *no* = trim atoms not in dump snapshot @@ -60,6 +61,7 @@ Examples read_dump dump.dcd 0 x y z box yes format molfile dcd read_dump dump.file 1000 x y z vx vy vz box yes format molfile lammpstrj /usr/local/lib/vmd/plugins/LINUXAMD64/plugins/molfile read_dump dump.file 5000 x y vx vy trim yes + read_dump dump.file 5000 x y vx vy add yes box no timestep no read_dump ../run7/dump.file.gz 10000 x y z box yes read_dump dump.xyz 10 x y z box no format molfile xyz ../plugins read_dump dump.dcd 0 x y z format molfile dcd @@ -71,9 +73,9 @@ Description """"""""""" Read atom information from a dump file to overwrite the current atom -coordinates, and optionally the atom velocities and image flags and -the simulation box dimensions. This is useful for restarting a run -from a particular snapshot in a dump file. See the +coordinates, and optionally the atom velocities and image flags, the +simulation timestep, and the simulation box dimensions. This is useful +for restarting a run from a particular snapshot in a dump file. See the :doc:`read_restart ` and :doc:`read_data ` commands for alternative methods to do this. Also see the :doc:`rerun ` command for a means of reading multiple snapshots @@ -89,9 +91,9 @@ Also note that reading per-atom information from a dump snapshot is limited to the atom coordinates, velocities and image flags, as explained below. Other atom properties, which may be necessary to run a valid simulation, such as atom charge, or bond topology information -for a molecular system, are not read from (or even contained in) dump -files. Thus this auxiliary information should be defined in the usual -way, e.g. in a data file read in by a :doc:`read_data ` +for a molecular system, are not read from (or may not even be contained +in) dump files. Thus this auxiliary information should be defined in +the usual way, e.g. in a data file read in by a :doc:`read_data ` command, before using the read_dump command, or by the :doc:`set ` command, after the dump snapshot is read. @@ -165,11 +167,10 @@ variable *ntimestep*: uint64_t ntimestep 5*scalar (0) 0 50 100 150 200 -Note that the *xyz* -and *molfile* formats do not store the timestep. For these formats, -timesteps are numbered logically, in a sequential manner, starting -from 0. Thus to access the 10th snapshot in an *xyz* or *mofile* -formatted dump file, use *Nstep* = 9. +Note that the *xyz* and *molfile* formats do not store the timestep. +For these formats, timesteps are numbered logically, in a sequential +manner, starting from 0. Thus to access the 10th snapshot in an *xyz* +or *mofile* formatted dump file, use *Nstep* = 9. The dimensions of the simulation box for the selected snapshot are also read; see the *box* keyword discussion below. For the *native* @@ -266,8 +267,10 @@ for how this is done, determined by the specified fields and optional keywords. The timestep of the snapshot becomes the current timestep for the -simulation. See the :doc:`reset_timestep ` command if -you wish to change this after the dump snapshot is read. +simulation unless the *timestep* keyword is specified with a *no* value +(default setting is *yes*). See the :doc:`reset_timestep ` +command if you wish to change this to a different value after the dump +snapshot is read. If the *box* keyword is specified with a *yes* value, then the current simulation box dimensions are replaced by the dump snapshot box @@ -391,7 +394,7 @@ Related commands Default """"""" -The option defaults are box = yes, replace = yes, purge = no, trim = -no, add = no, scaled = no, wrapped = yes, and format = native. +The option defaults are box = yes, timestep = yes, replace = yes, purge = no, +trim = no, add = no, scaled = no, wrapped = yes, and format = native. .. _vmd: http://www.ks.uiuc.edu/Research/vmd diff --git a/src/read_dump.cpp b/src/read_dump.cpp index 8af19ee601..aa9ec0bbf0 100644 --- a/src/read_dump.cpp +++ b/src/read_dump.cpp @@ -121,7 +121,7 @@ void ReadDump::command(int narg, char **arg) // reset timestep to nstep - update->reset_timestep(nstep, true); + if (timestepflag) update->reset_timestep(nstep, true); // counters @@ -1202,6 +1202,7 @@ int ReadDump::fields_and_keywords(int narg, char **arg) multiproc_nfile = 0; boxflag = 1; + timestepflag = 1; replaceflag = 1; purgeflag = 0; trimflag = 0; @@ -1219,6 +1220,10 @@ int ReadDump::fields_and_keywords(int narg, char **arg) if (iarg+2 > narg) error->all(FLERR,"Illegal read_dump command"); boxflag = utils::logical(FLERR,arg[iarg+1],false,lmp); iarg += 2; + } else if (strcmp(arg[iarg],"timestep") == 0) { + if (iarg+2 > narg) error->all(FLERR,"Illegal read_dump command"); + timestepflag = utils::logical(FLERR,arg[iarg+1],false,lmp); + iarg += 2; } else if (strcmp(arg[iarg],"replace") == 0) { if (iarg+2 > narg) error->all(FLERR,"Illegal read_dump command"); replaceflag = utils::logical(FLERR,arg[iarg+1],false,lmp); diff --git a/src/read_dump.h b/src/read_dump.h index 1a94cd1cd3..506cd197c1 100644 --- a/src/read_dump.h +++ b/src/read_dump.h @@ -63,7 +63,8 @@ class ReadDump : public Command { int dimension; // same as in Domain int triclinic; - int boxflag; // overwrite simulation with dump file box params + int boxflag; // overwrite simulation box with dump file box params + int timestepflag; // overwrite simulation timestep with dump file timestep int replaceflag, addflag; // flags for processing dump snapshot atoms int trimflag, purgeflag; int scaleflag; // user 0/1 if dump file coords are unscaled/scaled From 97824a6d462478b9361fe6a385ffe2752c45c77e Mon Sep 17 00:00:00 2001 From: Stan Gerald Moore Date: Mon, 11 Jul 2022 09:04:51 -0600 Subject: [PATCH 567/585] Fix logic issue --- src/neigh_list.cpp | 2 ++ src/neighbor.cpp | 17 ++++++++++++----- 2 files changed, 14 insertions(+), 5 deletions(-) diff --git a/src/neigh_list.cpp b/src/neigh_list.cpp index 3fbbd81d2e..d8fe7a8c27 100644 --- a/src/neigh_list.cpp +++ b/src/neigh_list.cpp @@ -289,6 +289,8 @@ void NeighList::print_attributes() printf(" %d = skip flag\n",rq->skip); printf(" %d = off2on\n",rq->off2on); printf(" %d = copy flag\n",rq->copy); + printf(" %d = trim flag\n",rq->trim); + printf(" %d = kk2cpu flag\n",kk2cpu); printf(" %d = half/full\n",rq->halffull); printf("\n"); } diff --git a/src/neighbor.cpp b/src/neighbor.cpp index 1a790169e3..7db84a6945 100644 --- a/src/neighbor.cpp +++ b/src/neighbor.cpp @@ -1354,6 +1354,7 @@ void Neighbor::morph_halffull() for (i = 0; i < nrequest; i++) { irq = requests[i]; + int trim_flag = irq->trim; // only processing half lists @@ -1387,7 +1388,7 @@ void Neighbor::morph_halffull() else jcut = cutneighmax; if (icut > jcut) continue; - else if (icut != jcut) irq->trim = 1; + else if (icut != jcut) trim_flag = 1; // these flags must be same, // else 2 lists do not store same pairs @@ -1419,7 +1420,8 @@ void Neighbor::morph_halffull() if (jj < nrequest) { irq->halffull = 1; irq->halffulllist = j; - } else irq->trim = 0; + irq->trim = trim_flag; + } } } @@ -1436,6 +1438,7 @@ void Neighbor::morph_copy_trim() for (i = 0; i < nrequest; i++) { irq = requests[i]; + int trim_flag = irq->trim; // this list is already a copy list due to another morph method @@ -1463,7 +1466,7 @@ void Neighbor::morph_copy_trim() else jcut = cutneighmax; if (icut > jcut) continue; - else if (icut != jcut) irq->trim = 1; + else if (icut != jcut) trim_flag = 1; // other list (jrq) to copy from must be perpetual // list that becomes a copy list (irq) can be perpetual or occasional @@ -1529,7 +1532,8 @@ void Neighbor::morph_copy_trim() irq->copy = 1; if (jrq->copy) irq->copylist = jrq->copylist; else irq->copylist = j; - } else irq->trim = 0; + irq->trim = trim_flag; + } } } @@ -1749,7 +1753,10 @@ void Neighbor::print_pairwise_info() else out += fmt::format(", copy from ({})",rq->copylist+1); } else if (rq->halffull) - out += fmt::format(", half/full from ({})",rq->halffulllist+1); + if (rq->trim) + out += fmt::format(", half/full trim from ({})",rq->halffulllist+1); + else + out += fmt::format(", half/full from ({})",rq->halffulllist+1); else if (rq->skip) out += fmt::format(", skip from ({})",rq->skiplist+1); out += "\n"; From c817a495e7b9ec965a3a77f4c85cb5da106dc6e2 Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Mon, 11 Jul 2022 09:44:23 -0600 Subject: [PATCH 568/585] tweak README files --- examples/amoeba/README | 3 ++- tools/tinker/README | 2 +- 2 files changed, 3 insertions(+), 2 deletions(-) diff --git a/examples/amoeba/README b/examples/amoeba/README index 7207593c47..969ecf4e22 100644 --- a/examples/amoeba/README +++ b/examples/amoeba/README @@ -1,4 +1,5 @@ -Data files in this directory were created by the tools/tinker/tinker2lmp.py script +Data files in this directory were created using the +tools/tinker/tinker2lmp.py script as follows: ** water_dimer: diff --git a/tools/tinker/README b/tools/tinker/README index 04ee066642..018db181c8 100644 --- a/tools/tinker/README +++ b/tools/tinker/README @@ -1,4 +1,4 @@ -Examples of how this tool created the data files in the +Examples for how this tool created the data files in the examples/amoeba directory: ** water_dimer: From 1bdaf9c99fa57ec66efeba52dc2e89916b7bfdb1 Mon Sep 17 00:00:00 2001 From: Stan Gerald Moore Date: Mon, 11 Jul 2022 10:22:08 -0600 Subject: [PATCH 569/585] Small tweak to clarify doc page --- doc/src/pair_modify.rst | 11 +++++++---- src/neigh_request.h | 2 +- 2 files changed, 8 insertions(+), 5 deletions(-) diff --git a/doc/src/pair_modify.rst b/doc/src/pair_modify.rst index 506867f2a3..e843acee16 100644 --- a/doc/src/pair_modify.rst +++ b/doc/src/pair_modify.rst @@ -287,9 +287,10 @@ the *pair* keyword. Use *no* to disable, or *yes* to enable. The *neigh/trim* keyword controls whether an explicit cutoff is set for each neighbor list requested by the individual pair sub-styles when using :doc:`pair hybrid\*/overlay `. When -this keyword is set to *no*, then the cutoff of the pair sub-style -neighbor will be set to the master list distance, and if possible the -neighbor list will be copied directly from another list. When this +this keyword is set to *no*, then the cutoff of each pair sub-style +neighbor list will be set equal to the largest cutoff, even if a +shorter cutoff is specified for a particular sub-style. If possible +the neighbor list will be copied directly from another list. When this keyword is set to *yes* then the cutoff of the neighbor list will be explicitly set to the value requested by the pair sub-style, and if possible the list will be created by trimming from another list with a @@ -297,7 +298,9 @@ longer cutoff, otherwise a new neighbor list will be created with the specified cutoff. The *yes* option can be faster when there are multiple pair styles with different cutoffs since the number of pair-wise distance checks between neighbors is reduced (but the time -required to build the neighbor lists is increased). +required to build the neighbor lists is increased). The *no* option +could be faster when two or more neighbor lists have similar (but not +exactly the same) cutoffs. .. note:: diff --git a/src/neigh_request.h b/src/neigh_request.h index 9dfc03f7f0..13b5b11466 100644 --- a/src/neigh_request.h +++ b/src/neigh_request.h @@ -102,7 +102,7 @@ class NeighRequest : protected Pointers { int off2on; // 1 if this is newton on list, but skips from off list int copy; // 1 if this list copied from another list - int trim; // 1 if this list copied from another list and then trimmed + int trim; // 1 if this list trimmed from another list int copylist; // index of list to copy from int halffull; // 1 if half list computed from another full list From 6ffde544e1e575c29f9938433cc283b5a1b5c1bf Mon Sep 17 00:00:00 2001 From: Stan Gerald Moore Date: Mon, 11 Jul 2022 10:23:55 -0600 Subject: [PATCH 570/585] Change default --- doc/src/pair_modify.rst | 2 +- src/pair.cpp | 2 +- 2 files changed, 2 insertions(+), 2 deletions(-) diff --git a/doc/src/pair_modify.rst b/doc/src/pair_modify.rst index e843acee16..a0161b35e5 100644 --- a/doc/src/pair_modify.rst +++ b/doc/src/pair_modify.rst @@ -328,7 +328,7 @@ Default """"""" The option defaults are mix = geometric, shift = no, table = 12, -tabinner = sqrt(2.0), tail = no, compute = yes, and neigh/trim no. +tabinner = sqrt(2.0), tail = no, compute = yes, and neigh/trim yes. Note that some pair styles perform mixing, but only a certain style of mixing. See the doc pages for individual pair styles for details. diff --git a/src/pair.cpp b/src/pair.cpp index ff56cf4967..4d42035fd1 100644 --- a/src/pair.cpp +++ b/src/pair.cpp @@ -97,7 +97,7 @@ Pair::Pair(LAMMPS *lmp) : Pointers(lmp) tabinner_disp = sqrt(2.0); ftable = nullptr; fdisptable = nullptr; - trim_flag = 0; + trim_flag = 1; allocated = 0; suffix_flag = Suffix::NONE; From 66b99008ef1edd7c71460c4aa438dd7cc702caa0 Mon Sep 17 00:00:00 2001 From: Stan Gerald Moore Date: Mon, 11 Jul 2022 11:18:54 -0600 Subject: [PATCH 571/585] Fix memory issue --- src/neighbor.cpp | 11 +++++++---- 1 file changed, 7 insertions(+), 4 deletions(-) diff --git a/src/neighbor.cpp b/src/neighbor.cpp index 7db84a6945..0feeb0a219 100644 --- a/src/neighbor.cpp +++ b/src/neighbor.cpp @@ -830,10 +830,6 @@ int Neighbor::init_pair() "with ghost info"); } - // sort requests by cutoff distance for trimming - - sort_requests(); - // morph requests in various ways // purpose is to avoid duplicate or inefficient builds // may add new requests if a needed request to derive from does not exist @@ -854,6 +850,13 @@ int Neighbor::init_pair() morph_unique(); morph_skip(); morph_granular(); // this method can change flags set by requestor + + // sort requests by cutoff distance for trimming, used by + // morph_halffull and morph_copy_trim. Must come after + // morph_skip() which change the number of reqeuests + + sort_requests(); + morph_halffull(); morph_copy_trim(); From f795cf0001b5301151071cb890e7523e92bc76a4 Mon Sep 17 00:00:00 2001 From: Stan Gerald Moore Date: Mon, 11 Jul 2022 11:22:06 -0600 Subject: [PATCH 572/585] typo --- src/neighbor.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/neighbor.cpp b/src/neighbor.cpp index 0feeb0a219..35b86ff106 100644 --- a/src/neighbor.cpp +++ b/src/neighbor.cpp @@ -853,7 +853,7 @@ int Neighbor::init_pair() // sort requests by cutoff distance for trimming, used by // morph_halffull and morph_copy_trim. Must come after - // morph_skip() which change the number of reqeuests + // morph_skip() which change the number of requests sort_requests(); From 51ac15bdc79aca959b51ec38588749985113bc11 Mon Sep 17 00:00:00 2001 From: Stan Gerald Moore Date: Mon, 11 Jul 2022 17:06:12 -0600 Subject: [PATCH 573/585] Fix sorting issue --- src/neighbor.cpp | 10 ++++++---- 1 file changed, 6 insertions(+), 4 deletions(-) diff --git a/src/neighbor.cpp b/src/neighbor.cpp index 35b86ff106..61035ce36c 100644 --- a/src/neighbor.cpp +++ b/src/neighbor.cpp @@ -1122,7 +1122,7 @@ void Neighbor::sort_requests() for (i = 0; i < nrequest; i++) { double cutoff_min = cutneighmax; - for (j = i; j < nrequest; j++) { + for (j = i; j < nrequest-1; j++) { jrq = requests[j_sorted[j]]; if (jrq->cut) jcut = jrq->cutoff; else jcut = cutneighmax; @@ -1133,7 +1133,7 @@ void Neighbor::sort_requests() } } int tmp = j_sorted[i]; - j_sorted[i] = jmin; + j_sorted[i] = j_sorted[jmin]; j_sorted[jmin] = tmp; } } @@ -1533,9 +1533,11 @@ void Neighbor::morph_copy_trim() if (jj < nrequest) { irq->copy = 1; - if (jrq->copy) irq->copylist = jrq->copylist; - else irq->copylist = j; irq->trim = trim_flag; + if (jrq->copy && irq->cutoff == requests[jrq->copylist]->cutoff) + irq->copylist = jrq->copylist; + else + irq->copylist = j; } } } From f0d8ced6ffc8a1a67c2619f38138d76a7049a20b Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 12 Jul 2022 00:03:36 -0400 Subject: [PATCH 574/585] fix uninitialized variable bug --- src/neighbor.cpp | 1 + 1 file changed, 1 insertion(+) diff --git a/src/neighbor.cpp b/src/neighbor.cpp index 61035ce36c..deafc94a19 100644 --- a/src/neighbor.cpp +++ b/src/neighbor.cpp @@ -1121,6 +1121,7 @@ void Neighbor::sort_requests() for (i = 0; i < nrequest; i++) { double cutoff_min = cutneighmax; + jmin = i; for (j = i; j < nrequest-1; j++) { jrq = requests[j_sorted[j]]; From 4cb38038c8baed0412e1ef821bf503004c9fb6a4 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 12 Jul 2022 00:14:26 -0400 Subject: [PATCH 575/585] fix segfault in pair style hybrid/scaled due to unallocated data --- src/pair_hybrid_scaled.cpp | 2 ++ 1 file changed, 2 insertions(+) diff --git a/src/pair_hybrid_scaled.cpp b/src/pair_hybrid_scaled.cpp index 2c0c574f70..a059deb3fb 100644 --- a/src/pair_hybrid_scaled.cpp +++ b/src/pair_hybrid_scaled.cpp @@ -276,6 +276,8 @@ void PairHybridScaled::settings(int narg, char **arg) // allocate list of sub-styles as big as possibly needed if no extra args styles = new Pair *[narg]; + cutmax_style = new double[narg]; + memset(cutmax_style, 0.0, narg*sizeof(double)); keywords = new char *[narg]; multiple = new int[narg]; From 56dc342b5b22b25f6e21e2ab2df3e0314ddb0acf Mon Sep 17 00:00:00 2001 From: Stan Gerald Moore Date: Tue, 12 Jul 2022 08:25:20 -0600 Subject: [PATCH 576/585] Disable trim from OPENMP and INTEL packages --- src/neighbor.cpp | 38 ++++++++++++++++++++++++-------------- 1 file changed, 24 insertions(+), 14 deletions(-) diff --git a/src/neighbor.cpp b/src/neighbor.cpp index deafc94a19..07eaf156a0 100644 --- a/src/neighbor.cpp +++ b/src/neighbor.cpp @@ -1383,16 +1383,21 @@ void Neighbor::morph_halffull() if (jrq->occasional) continue; if (!jrq->full) continue; - // trim a list with longer cutoff + // trim a list with longer cutoff (not yet supported by OPENMP or INTEL) - if (irq->cut) icut = irq->cutoff; - else icut = cutneighmax; + if (irq->omp || irq->intel) { + if (irq->cut != jrq->cut) continue; + if (irq->cutoff != jrq->cutoff) continue; + } else { + if (irq->cut) icut = irq->cutoff; + else icut = cutneighmax; - if (jrq->cut) jcut = jrq->cutoff; - else jcut = cutneighmax; + if (jrq->cut) jcut = jrq->cutoff; + else jcut = cutneighmax; - if (icut > jcut) continue; - else if (icut != jcut) trim_flag = 1; + if (icut > jcut) continue; + else if (icut != jcut) trim_flag = 1; + } // these flags must be same, // else 2 lists do not store same pairs @@ -1461,16 +1466,21 @@ void Neighbor::morph_copy_trim() if (jrq->copy && jrq->copylist == i) continue; - // trim a list with longer cutoff + // trim a list with longer cutoff (not yet supported by OPENMP or INTEL) - if (irq->cut) icut = irq->cutoff; - else icut = cutneighmax; + if (irq->omp || irq->intel) { + if (irq->cut != jrq->cut) continue; + if (irq->cutoff != jrq->cutoff) continue; + } else { + if (irq->cut) icut = irq->cutoff; + else icut = cutneighmax; - if (jrq->cut) jcut = jrq->cutoff; - else jcut = cutneighmax; + if (jrq->cut) jcut = jrq->cutoff; + else jcut = cutneighmax; - if (icut > jcut) continue; - else if (icut != jcut) trim_flag = 1; + if (icut > jcut) continue; + else if (icut != jcut) trim_flag = 1; + } // other list (jrq) to copy from must be perpetual // list that becomes a copy list (irq) can be perpetual or occasional From bc79fc6fa3374026e7011e5109e8048f553f2600 Mon Sep 17 00:00:00 2001 From: Stan Gerald Moore Date: Tue, 12 Jul 2022 08:26:39 -0600 Subject: [PATCH 577/585] Clarify docs --- doc/src/pair_modify.rst | 3 ++- 1 file changed, 2 insertions(+), 1 deletion(-) diff --git a/doc/src/pair_modify.rst b/doc/src/pair_modify.rst index a0161b35e5..70e0e6c870 100644 --- a/doc/src/pair_modify.rst +++ b/doc/src/pair_modify.rst @@ -305,7 +305,8 @@ exactly the same) cutoffs. .. note:: The "pair_modify neigh/trim" command only applies when there are - multiple pair sub-styles, i.e. when using pair hybrid/overlay + multiple pair sub-styles with different cutoffs, i.e. when using + pair hybrid/overlay ---------- From d67ab73a892f73bf514f1a7a1041ab1741fb8cfb Mon Sep 17 00:00:00 2001 From: Stan Gerald Moore Date: Tue, 12 Jul 2022 09:13:07 -0600 Subject: [PATCH 578/585] Revert 56dc342 --- src/neighbor.cpp | 38 ++++++++++++++------------------------ 1 file changed, 14 insertions(+), 24 deletions(-) diff --git a/src/neighbor.cpp b/src/neighbor.cpp index 07eaf156a0..deafc94a19 100644 --- a/src/neighbor.cpp +++ b/src/neighbor.cpp @@ -1383,21 +1383,16 @@ void Neighbor::morph_halffull() if (jrq->occasional) continue; if (!jrq->full) continue; - // trim a list with longer cutoff (not yet supported by OPENMP or INTEL) + // trim a list with longer cutoff - if (irq->omp || irq->intel) { - if (irq->cut != jrq->cut) continue; - if (irq->cutoff != jrq->cutoff) continue; - } else { - if (irq->cut) icut = irq->cutoff; - else icut = cutneighmax; + if (irq->cut) icut = irq->cutoff; + else icut = cutneighmax; - if (jrq->cut) jcut = jrq->cutoff; - else jcut = cutneighmax; + if (jrq->cut) jcut = jrq->cutoff; + else jcut = cutneighmax; - if (icut > jcut) continue; - else if (icut != jcut) trim_flag = 1; - } + if (icut > jcut) continue; + else if (icut != jcut) trim_flag = 1; // these flags must be same, // else 2 lists do not store same pairs @@ -1466,21 +1461,16 @@ void Neighbor::morph_copy_trim() if (jrq->copy && jrq->copylist == i) continue; - // trim a list with longer cutoff (not yet supported by OPENMP or INTEL) + // trim a list with longer cutoff - if (irq->omp || irq->intel) { - if (irq->cut != jrq->cut) continue; - if (irq->cutoff != jrq->cutoff) continue; - } else { - if (irq->cut) icut = irq->cutoff; - else icut = cutneighmax; + if (irq->cut) icut = irq->cutoff; + else icut = cutneighmax; - if (jrq->cut) jcut = jrq->cutoff; - else jcut = cutneighmax; + if (jrq->cut) jcut = jrq->cutoff; + else jcut = cutneighmax; - if (icut > jcut) continue; - else if (icut != jcut) trim_flag = 1; - } + if (icut > jcut) continue; + else if (icut != jcut) trim_flag = 1; // other list (jrq) to copy from must be perpetual // list that becomes a copy list (irq) can be perpetual or occasional From 1cc5b8aa950d1f58a26c638b7dba03975539e6c2 Mon Sep 17 00:00:00 2001 From: Stan Gerald Moore Date: Tue, 12 Jul 2022 09:14:52 -0600 Subject: [PATCH 579/585] Add trim methods from OPENMP --- .../npair_halffull_newtoff_trim_omp.cpp | 109 ++++++++++++++++ src/OPENMP/npair_halffull_newtoff_trim_omp.h | 44 +++++++ src/OPENMP/npair_halffull_newton_trim_omp.cpp | 118 ++++++++++++++++++ src/OPENMP/npair_halffull_newton_trim_omp.h | 44 +++++++ src/OPENMP/npair_trim_omp.cpp | 108 ++++++++++++++++ src/OPENMP/npair_trim_omp.h | 39 ++++++ 6 files changed, 462 insertions(+) create mode 100644 src/OPENMP/npair_halffull_newtoff_trim_omp.cpp create mode 100644 src/OPENMP/npair_halffull_newtoff_trim_omp.h create mode 100644 src/OPENMP/npair_halffull_newton_trim_omp.cpp create mode 100644 src/OPENMP/npair_halffull_newton_trim_omp.h create mode 100644 src/OPENMP/npair_trim_omp.cpp create mode 100644 src/OPENMP/npair_trim_omp.h diff --git a/src/OPENMP/npair_halffull_newtoff_trim_omp.cpp b/src/OPENMP/npair_halffull_newtoff_trim_omp.cpp new file mode 100644 index 0000000000..727e284718 --- /dev/null +++ b/src/OPENMP/npair_halffull_newtoff_trim_omp.cpp @@ -0,0 +1,109 @@ +// clang-format off +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + https://www.lammps.org/, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#include "npair_halffull_newtoff_trim_omp.h" + +#include "atom.h" +#include "error.h" +#include "my_page.h" +#include "neigh_list.h" +#include "npair_omp.h" + +#include "omp_compat.h" + +using namespace LAMMPS_NS; + +/* ---------------------------------------------------------------------- */ + +NPairHalffullNewtoffTrimOmp::NPairHalffullNewtoffTrimOmp(LAMMPS *lmp) : NPair(lmp) {} + +/* ---------------------------------------------------------------------- + build half list from full list and trim to shorter cutoff + pair stored once if i,j are both owned and i < j + pair stored by me if j is ghost (also stored by proc owning j) + works if full list is a skip list +------------------------------------------------------------------------- */ + +void NPairHalffullNewtoffTrimOmp::build(NeighList *list) +{ + const int inum_full = list->listfull->inum; + + NPAIR_OMP_INIT; + +#if defined(_OPENMP) +#pragma omp parallel LMP_DEFAULT_NONE LMP_SHARED(list) +#endif + NPAIR_OMP_SETUP(inum_full); + + int i,j,ii,jj,n,jnum,joriginal; + int *neighptr,*jlist; + double xtmp,ytmp,ztmp; + double delx,dely,delz,rsq; + + double **x = atom->x; + + int *ilist = list->ilist; + int *numneigh = list->numneigh; + int **firstneigh = list->firstneigh; + int *ilist_full = list->listfull->ilist; + int *numneigh_full = list->listfull->numneigh; + int **firstneigh_full = list->listfull->firstneigh; + + // each thread has its own page allocator + MyPage &ipage = list->ipage[tid]; + ipage.reset(); + + double cutsq_custom = cutoff_custom * cutoff_custom; + + // loop over atoms in full list + + for (ii = ifrom; ii < ito; ii++) { + + n = 0; + neighptr = ipage.vget(); + + // loop over parent full list + + i = ilist_full[ii]; + xtmp = x[i][0]; + ytmp = x[i][1]; + ztmp = x[i][2]; + + jlist = firstneigh_full[i]; + jnum = numneigh_full[i]; + + for (jj = 0; jj < jnum; jj++) { + joriginal = jlist[jj]; + j = joriginal & NEIGHMASK; + + delx = xtmp - x[j][0]; + dely = ytmp - x[j][1]; + delz = ztmp - x[j][2]; + rsq = delx * delx + dely * dely + delz * delz; + + if (rsq > cutsq_custom) continue; + + if (j > i) neighptr[n++] = joriginal; + } + + ilist[ii] = i; + firstneigh[i] = neighptr; + numneigh[i] = n; + ipage.vgot(n); + if (ipage.status()) + error->one(FLERR,"Neighbor list overflow, boost neigh_modify one"); + } + NPAIR_OMP_CLOSE; + list->inum = inum_full; +} diff --git a/src/OPENMP/npair_halffull_newtoff_trim_omp.h b/src/OPENMP/npair_halffull_newtoff_trim_omp.h new file mode 100644 index 0000000000..6d701b5cb6 --- /dev/null +++ b/src/OPENMP/npair_halffull_newtoff_trim_omp.h @@ -0,0 +1,44 @@ +/* -*- c++ -*- ---------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + https://www.lammps.org/, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#ifdef NPAIR_CLASS +// clang-format off +NPairStyle(halffull/newtoff/trim/omp, + NPairHalffullNewtoffTrimOmp, + NP_HALF_FULL | NP_NEWTOFF | NP_NSQ | NP_BIN | NP_MULTI | NP_MULTI_OLD | NP_HALF | + NP_ORTHO | NP_TRI | NP_TRIM | NP_OMP); + +NPairStyle(halffull/newtoff/skip/trim/omp, + NPairHalffullNewtoffTrimOmp, + NP_HALF_FULL | NP_NEWTOFF | NP_NSQ | NP_BIN | NP_MULTI | NP_MULTI_OLD | NP_HALF | + NP_ORTHO | NP_TRI | NP_SKIP | NP_TRIM | NP_OMP); +// clang-format on +#else + +#ifndef LMP_NPAIR_HALFFULL_NEWTOFF_TRIM_OMP_H +#define LMP_NPAIR_HALFFULL_NEWTOFF_TRIM_OMP_H + +#include "npair.h" + +namespace LAMMPS_NS { + +class NPairHalffullNewtoffTrimOmp : public NPair { + public: + NPairHalffullNewtoffTrimOmp(class LAMMPS *); + void build(class NeighList *) override; +}; + +} // namespace LAMMPS_NS + +#endif +#endif diff --git a/src/OPENMP/npair_halffull_newton_trim_omp.cpp b/src/OPENMP/npair_halffull_newton_trim_omp.cpp new file mode 100644 index 0000000000..df0e40bfc6 --- /dev/null +++ b/src/OPENMP/npair_halffull_newton_trim_omp.cpp @@ -0,0 +1,118 @@ +// clang-format off +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + https://www.lammps.org/, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#include "npair_halffull_newton_trim_omp.h" + +#include "atom.h" +#include "error.h" +#include "my_page.h" +#include "neigh_list.h" +#include "npair_omp.h" + +#include "omp_compat.h" + +using namespace LAMMPS_NS; + +/* ---------------------------------------------------------------------- */ + +NPairHalffullNewtonTrimOmp::NPairHalffullNewtonTrimOmp(LAMMPS *lmp) : NPair(lmp) {} + +/* ---------------------------------------------------------------------- + build half list from full list and trim to shorter cutoff + pair stored once if i,j are both owned and i < j + if j is ghost, only store if j coords are "above and to the right" of i + works if full list is a skip list +------------------------------------------------------------------------- */ + +void NPairHalffullNewtonTrimOmp::build(NeighList *list) +{ + const int inum_full = list->listfull->inum; + + NPAIR_OMP_INIT; +#if defined(_OPENMP) +#pragma omp parallel LMP_DEFAULT_NONE LMP_SHARED(list) +#endif + NPAIR_OMP_SETUP(inum_full); + + int i,j,ii,jj,n,jnum,joriginal; + int *neighptr,*jlist; + double xtmp,ytmp,ztmp; + double delx,dely,delz,rsq; + + double **x = atom->x; + int nlocal = atom->nlocal; + + int *ilist = list->ilist; + int *numneigh = list->numneigh; + int **firstneigh = list->firstneigh; + int *ilist_full = list->listfull->ilist; + int *numneigh_full = list->listfull->numneigh; + int **firstneigh_full = list->listfull->firstneigh; + + // each thread has its own page allocator + MyPage &ipage = list->ipage[tid]; + ipage.reset(); + + double cutsq_custom = cutoff_custom * cutoff_custom; + + // loop over parent full list + + for (ii = ifrom; ii < ito; ii++) { + + n = 0; + neighptr = ipage.vget(); + + i = ilist_full[ii]; + xtmp = x[i][0]; + ytmp = x[i][1]; + ztmp = x[i][2]; + + // loop over full neighbor list + + jlist = firstneigh_full[i]; + jnum = numneigh_full[i]; + + for (jj = 0; jj < jnum; jj++) { + joriginal = jlist[jj]; + j = joriginal & NEIGHMASK; + if (j < nlocal) { + if (i > j) continue; + } else { + if (x[j][2] < ztmp) continue; + if (x[j][2] == ztmp) { + if (x[j][1] < ytmp) continue; + if (x[j][1] == ytmp && x[j][0] < xtmp) continue; + } + } + + delx = xtmp - x[j][0]; + dely = ytmp - x[j][1]; + delz = ztmp - x[j][2]; + rsq = delx * delx + dely * dely + delz * delz; + + if (rsq > cutsq_custom) continue; + + neighptr[n++] = joriginal; + } + + ilist[ii] = i; + firstneigh[i] = neighptr; + numneigh[i] = n; + ipage.vgot(n); + if (ipage.status()) + error->one(FLERR,"Neighbor list overflow, boost neigh_modify one"); + } + NPAIR_OMP_CLOSE; + list->inum = inum_full; +} diff --git a/src/OPENMP/npair_halffull_newton_trim_omp.h b/src/OPENMP/npair_halffull_newton_trim_omp.h new file mode 100644 index 0000000000..a774a68c2b --- /dev/null +++ b/src/OPENMP/npair_halffull_newton_trim_omp.h @@ -0,0 +1,44 @@ +/* -*- c++ -*- ---------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + https://www.lammps.org/, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#ifdef NPAIR_CLASS +// clang-format off +NPairStyle(halffull/newton/trim/omp, + NPairHalffullNewtonTrimOmp, + NP_HALF_FULL | NP_NEWTON | NP_HALF | NP_NSQ | NP_BIN | NP_MULTI | NP_MULTI_OLD | + NP_ORTHO | NP_TRI| NP_TRIM | NP_OMP); + +NPairStyle(halffull/newton/skip/trim/omp, + NPairHalffullNewtonTrimOmp, + NP_HALF_FULL | NP_NEWTON | NP_HALF | NP_NSQ | NP_BIN | NP_MULTI | NP_MULTI_OLD | + NP_ORTHO | NP_TRI | NP_SKIP | NP_TRIM | NP_OMP); +// clang-format on +#else + +#ifndef LMP_NPAIR_HALFFULL_NEWTON_TRIM_OMP_H +#define LMP_NPAIR_HALFFULL_NEWTON_TRIM_OMP_H + +#include "npair.h" + +namespace LAMMPS_NS { + +class NPairHalffullNewtonTrimOmp : public NPair { + public: + NPairHalffullNewtonTrimOmp(class LAMMPS *); + void build(class NeighList *) override; +}; + +} // namespace LAMMPS_NS + +#endif +#endif diff --git a/src/OPENMP/npair_trim_omp.cpp b/src/OPENMP/npair_trim_omp.cpp new file mode 100644 index 0000000000..4b3b835f8c --- /dev/null +++ b/src/OPENMP/npair_trim_omp.cpp @@ -0,0 +1,108 @@ +// clang-format off +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + https://www.lammps.org/, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#include "npair_trim_omp.h" + +#include "atom.h" +#include "error.h" +#include "my_page.h" +#include "neigh_list.h" +#include "npair_omp.h" + +#include "omp_compat.h" + +using namespace LAMMPS_NS; + +/* ---------------------------------------------------------------------- */ + +NPairTrimOmp::NPairTrimOmp(LAMMPS *lmp) : NPair(lmp) {} + +/* ---------------------------------------------------------------------- + trim from copy list to shorter cutoff +------------------------------------------------------------------------- */ + +void NPairTrimOmp::build(NeighList *list) +{ + const int inum_copy = list->listcopy->inum; + + NPAIR_OMP_INIT; + +#if defined(_OPENMP) +#pragma omp parallel LMP_DEFAULT_NONE LMP_SHARED(list) +#endif + NPAIR_OMP_SETUP(inum_copy); + + int i,j,ii,jj,n,jnum,joriginal; + int *neighptr,*jlist; + double xtmp,ytmp,ztmp; + double delx,dely,delz,rsq; + + double **x = atom->x; + + int *ilist = list->ilist; + int *numneigh = list->numneigh; + int **firstneigh = list->firstneigh; + int *ilist_copy = list->listcopy->ilist; + int *numneigh_copy = list->listcopy->numneigh; + int **firstneigh_copy = list->listcopy->firstneigh; + + // each thread has its own page allocator + MyPage &ipage = list->ipage[tid]; + ipage.reset(); + + double cutsq_custom = cutoff_custom * cutoff_custom; + + // loop over atoms in copy list + + for (ii = ifrom; ii < ito; ii++) { + + n = 0; + neighptr = ipage.vget(); + + // loop over parent copy list + + i = ilist_copy[ii]; + xtmp = x[i][0]; + ytmp = x[i][1]; + ztmp = x[i][2]; + + jlist = firstneigh_copy[i]; + jnum = numneigh_copy[i]; + + for (jj = 0; jj < jnum; jj++) { + joriginal = jlist[jj]; + j = joriginal & NEIGHMASK; + + // trim to shorter cutoff + + delx = xtmp - x[j][0]; + dely = ytmp - x[j][1]; + delz = ztmp - x[j][2]; + rsq = delx * delx + dely * dely + delz * delz; + + if (rsq > cutsq_custom) continue; + + neighptr[n++] = joriginal; + } + + ilist[ii] = i; + firstneigh[i] = neighptr; + numneigh[i] = n; + ipage.vgot(n); + if (ipage.status()) + error->one(FLERR,"Neighbor list overflow, boost neigh_modify one"); + } + NPAIR_OMP_CLOSE; + list->inum = inum_copy; +} diff --git a/src/OPENMP/npair_trim_omp.h b/src/OPENMP/npair_trim_omp.h new file mode 100644 index 0000000000..48cd9eb6a0 --- /dev/null +++ b/src/OPENMP/npair_trim_omp.h @@ -0,0 +1,39 @@ +/* -*- c++ -*- ---------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + https://www.lammps.org/, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#ifdef NPAIR_CLASS +// clang-format off +NPairStyle(trim/omp, + NPairTrimOmp, + NP_COPY | NP_TRIM | NP_OMP) + +// clang-format on +#else + +#ifndef LMP_NPAIR_TRIM_OMP_H +#define LMP_NPAIR_TRIM_OMP_H + +#include "npair.h" + +namespace LAMMPS_NS { + +class NPairTrimOmp : public NPair { + public: + NPairTrimOmp(class LAMMPS *); + void build(class NeighList *) override; +}; + +} // namespace LAMMPS_NS + +#endif +#endif From be1396dab0c37af319829b41f377ef1bc2d24eb6 Mon Sep 17 00:00:00 2001 From: Stan Gerald Moore Date: Tue, 12 Jul 2022 09:58:00 -0600 Subject: [PATCH 580/585] Add trim methods for INTEL --- src/INTEL/npair_halffull_newtoff_trim_intel.h | 44 +++ .../npair_halffull_newton_trim_intel.cpp | 258 ++++++++++++++++++ src/INTEL/npair_halffull_newton_trim_intel.h | 61 +++++ src/INTEL/npair_trim_intel.cpp | 138 ++++++++++ src/INTEL/npair_trim_intel.h | 53 ++++ 5 files changed, 554 insertions(+) create mode 100644 src/INTEL/npair_halffull_newtoff_trim_intel.h create mode 100644 src/INTEL/npair_halffull_newton_trim_intel.cpp create mode 100644 src/INTEL/npair_halffull_newton_trim_intel.h create mode 100644 src/INTEL/npair_trim_intel.cpp create mode 100644 src/INTEL/npair_trim_intel.h diff --git a/src/INTEL/npair_halffull_newtoff_trim_intel.h b/src/INTEL/npair_halffull_newtoff_trim_intel.h new file mode 100644 index 0000000000..923a0c8c95 --- /dev/null +++ b/src/INTEL/npair_halffull_newtoff_trim_intel.h @@ -0,0 +1,44 @@ +// clang-format off +/* -*- c++ -*- ---------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + https://www.lammps.org/, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +/* ---------------------------------------------------------------------- + Contributing author: Stan Moore (SNL) +------------------------------------------------------------------------- */ + +// Only used for hybrid to generate list for non-intel style. Use +// standard routines. + +#ifdef NPAIR_CLASS +// clang-format off +NPairStyle(halffull/newtoff/trim/intel, + NPairHalffullNewtoffTrim, + NP_HALF_FULL | NP_NEWTOFF | NP_NSQ | NP_BIN | NP_MULTI | NP_HALF | + NP_ORTHO | NP_TRI | NP_TRIM | NP_INTEL); + +NPairStyle(halffull/newtoff/skip/trim/intel, + NPairHalffullNewtoffTrim, + NP_HALF_FULL | NP_NEWTOFF | NP_NSQ | NP_BIN | NP_MULTI | NP_HALF | + NP_ORTHO | NP_TRI | NP_SKIP | NP_TRIM | NP_INTEL); + +NPairStyle(halffull/newtoff/ghost/trim/intel, + NPairHalffullNewtoffTrim, + NP_HALF_FULL | NP_NEWTOFF | NP_NSQ | NP_BIN | NP_MULTI | NP_HALF | + NP_ORTHO | NP_TRI | NP_GHOST | NP_TRIM | NP_INTEL); + +NPairStyle(halffull/newtoff/skip/ghost/trim/intel, + NPairHalffullNewtoffTrim, + NP_HALF_FULL | NP_NEWTOFF | NP_NSQ | NP_BIN | NP_MULTI | NP_HALF | + NP_ORTHO | NP_TRI | NP_SKIP | NP_GHOST | NP_TRIM | NP_INTEL); +// clang-format on +#endif diff --git a/src/INTEL/npair_halffull_newton_trim_intel.cpp b/src/INTEL/npair_halffull_newton_trim_intel.cpp new file mode 100644 index 0000000000..57b988b79b --- /dev/null +++ b/src/INTEL/npair_halffull_newton_trim_intel.cpp @@ -0,0 +1,258 @@ +// clang-format off +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + https://www.lammps.org/, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +/* ---------------------------------------------------------------------- + Contributing author: Stan Moore (SNL) +------------------------------------------------------------------------- */ + +#include "npair_halffull_newton_trim_intel.h" + +#include "atom.h" +#include "comm.h" +#include "error.h" +#include "modify.h" +#include "my_page.h" +#include "neigh_list.h" + +using namespace LAMMPS_NS; + +/* ---------------------------------------------------------------------- */ + +NPairHalffullNewtonTrimIntel::NPairHalffullNewtonTrimIntel(LAMMPS *lmp) : NPair(lmp) { + _fix = static_cast(modify->get_fix_by_id("package_intel")); + if (!_fix) error->all(FLERR, "The 'package intel' command is required for /intel styles"); +} + +/* ---------------------------------------------------------------------- + build half list from full list and trim to shorter cutoff + pair stored once if i,j are both owned and i < j + if j is ghost, only store if j coords are "above and to the right" of i + works if full list is a skip list +------------------------------------------------------------------------- */ + +template +void NPairHalffullNewtonTrimIntel::build_t(NeighList *list, + IntelBuffers *buffers) +{ + const int inum_full = list->listfull->inum; + const int nlocal = atom->nlocal; + const int e_nall = nlocal + atom->nghost; + const ATOM_T * _noalias const x = buffers->get_x(); + int * _noalias const ilist = list->ilist; + int * _noalias const numneigh = list->numneigh; + int ** _noalias const firstneigh = list->firstneigh; + const int * _noalias const ilist_full = list->listfull->ilist; + const int * _noalias const numneigh_full = list->listfull->numneigh; + const int ** _noalias const firstneigh_full = (const int ** const)list->listfull->firstneigh; // NOLINT + + const double cutsq_custom = cutoff_custom * cutoff_custom; + + #if defined(_OPENMP) + #pragma omp parallel + #endif + { + int tid, ifrom, ito; + IP_PRE_omp_range_id(ifrom, ito, tid, inum_full, comm->nthreads); + + // each thread has its own page allocator + MyPage &ipage = list->ipage[tid]; + ipage.reset(); + + // loop over parent full list + for (int ii = ifrom; ii < ito; ii++) { + int n = 0; + int *neighptr = ipage.vget(); + + const int i = ilist_full[ii]; + const flt_t xtmp = x[i].x; + const flt_t ytmp = x[i].y; + const flt_t ztmp = x[i].z; + + // loop over full neighbor list + + const int * _noalias const jlist = firstneigh_full[i]; + const int jnum = numneigh_full[i]; + + #if defined(LMP_SIMD_COMPILER) + #pragma vector aligned + #pragma ivdep + #endif + for (int jj = 0; jj < jnum; jj++) { + const int joriginal = jlist[jj]; + const int j = joriginal & NEIGHMASK; + int addme = 1; + if (j < nlocal) { + if (i > j) addme = 0; + } else { + if (x[j].z < ztmp) addme = 0; + if (x[j].z == ztmp) { + if (x[j].y < ytmp) addme = 0; + if (x[j].y == ytmp && x[j].x < xtmp) addme = 0; + } + } + + // trim to shorter cutoff + + const flt_t delx = xtmp - x[j].x; + const flt_t dely = ytmp - x[j].y; + const flt_t delz = ztmp - x[j].z; + const flt_t rsq = delx * delx + dely * dely + delz * delz; + + if (rsq > cutsq_custom) addme = 0; + + if (addme) + neighptr[n++] = joriginal; + } + + ilist[ii] = i; + firstneigh[i] = neighptr; + numneigh[i] = n; + + int pad_end = n; + IP_PRE_neighbor_pad(pad_end, 0); + #if defined(LMP_SIMD_COMPILER) + #pragma vector aligned + #pragma loop_count min=1, max=INTEL_COMPILE_WIDTH-1, \ + avg=INTEL_COMPILE_WIDTH/2 + #endif + for ( ; n < pad_end; n++) + neighptr[n] = e_nall; + + ipage.vgot(n); + if (ipage.status()) + error->one(FLERR,"Neighbor list overflow, boost neigh_modify one"); + } + } + list->inum = inum_full; +} + +/* ---------------------------------------------------------------------- + build half list from full 3-body list and trim to shorter cutoff + half list is already stored as first part of 3-body list +------------------------------------------------------------------------- */ + +template +void NPairHalffullNewtonTrimIntel::build_t3(NeighList *list, int *numhalf, + IntelBuffers *buffers) +{ + const int inum_full = list->listfull->inum; + const int e_nall = atom->nlocal + atom->nghost; + const ATOM_T * _noalias const x = buffers->get_x(); + int * _noalias const ilist = list->ilist; + int * _noalias const numneigh = list->numneigh; + int ** _noalias const firstneigh = list->firstneigh; + const int * _noalias const ilist_full = list->listfull->ilist; + const int * _noalias const numneigh_full = numhalf; + const int ** _noalias const firstneigh_full = (const int ** const)list->listfull->firstneigh; // NOLINT + + const double cutsq_custom = cutoff_custom * cutoff_custom; + + int packthreads = 1; + if (comm->nthreads > INTEL_HTHREADS) packthreads = comm->nthreads; + + #if defined(_OPENMP) + #pragma omp parallel if (packthreads > 1) + #endif + { + int tid, ifrom, ito; + IP_PRE_omp_range_id(ifrom, ito, tid, inum_full, packthreads); + + // each thread has its own page allocator + MyPage &ipage = list->ipage[tid]; + ipage.reset(); + + // loop over parent full list + for (int ii = ifrom; ii < ito; ii++) { + int n = 0; + int *neighptr = ipage.vget(); + + const int i = ilist_full[ii]; + const flt_t xtmp = x[i].x; + const flt_t ytmp = x[i].y; + const flt_t ztmp = x[i].z; + + // loop over full neighbor list + + const int * _noalias const jlist = firstneigh_full[i]; + const int jnum = numneigh_full[ii]; + + #if defined(LMP_SIMD_COMPILER) + #pragma vector aligned + #pragma ivdep + #endif + for (int jj = 0; jj < jnum; jj++) { + const int joriginal = jlist[jj]; + const int j = joriginal & NEIGHMASK; + int addme = 1; + + // trim to shorter cutoff + + const flt_t delx = xtmp - x[j].x; + const flt_t dely = ytmp - x[j].y; + const flt_t delz = ztmp - x[j].z; + const flt_t rsq = delx * delx + dely * dely + delz * delz; + + if (rsq > cutsq_custom) addme = 0; + + if (addme) + neighptr[n++] = joriginal; + } + + ilist[ii] = i; + firstneigh[i] = neighptr; + numneigh[i] = n; + + int pad_end = n; + IP_PRE_neighbor_pad(pad_end, 0); + #if defined(LMP_SIMD_COMPILER) + #pragma vector aligned + #pragma loop_count min=1, max=INTEL_COMPILE_WIDTH-1, \ + avg=INTEL_COMPILE_WIDTH/2 + #endif + for ( ; n < pad_end; n++) + neighptr[n] = e_nall; + + ipage.vgot(n); + if (ipage.status()) + error->one(FLERR,"Neighbor list overflow, boost neigh_modify one"); + } + } + list->inum = inum_full; +} + +/* ---------------------------------------------------------------------- */ + +void NPairHalffullNewtonTrimIntel::build(NeighList *list) +{ + if (_fix->three_body_neighbor() == 0) { + if (_fix->precision() == FixIntel::PREC_MODE_MIXED) + build_t(list, _fix->get_mixed_buffers()); + else if (_fix->precision() == FixIntel::PREC_MODE_DOUBLE) + build_t(list, _fix->get_double_buffers()); + else + build_t(list, _fix->get_single_buffers()); + } else { + int *nhalf, *cnum; + if (_fix->precision() == FixIntel::PREC_MODE_MIXED) { + _fix->get_mixed_buffers()->get_list_data3(list->listfull, nhalf, cnum); + build_t3(list, nhalf, _fix->get_mixed_buffers()); + } else if (_fix->precision() == FixIntel::PREC_MODE_DOUBLE) { + _fix->get_double_buffers()->get_list_data3(list->listfull, nhalf, cnum); + build_t3(list, nhalf, _fix->get_double_buffers()); + } else { + _fix->get_single_buffers()->get_list_data3(list->listfull, nhalf, cnum); + build_t3(list, nhalf, _fix->get_single_buffers()); + } + } +} diff --git a/src/INTEL/npair_halffull_newton_trim_intel.h b/src/INTEL/npair_halffull_newton_trim_intel.h new file mode 100644 index 0000000000..096cf3bd66 --- /dev/null +++ b/src/INTEL/npair_halffull_newton_trim_intel.h @@ -0,0 +1,61 @@ +// clang-format off +/* -*- c++ -*- ---------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + https://www.lammps.org/, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +/* ---------------------------------------------------------------------- + Contributing author: Stan Moore (SNL) +------------------------------------------------------------------------- */ + +#ifdef NPAIR_CLASS +// clang-format off +NPairStyle(halffull/newton/trim/intel, + NPairHalffullNewtonTrimIntel, + NP_HALF_FULL | NP_NEWTON | NP_HALF | NP_NSQ | NP_BIN | NP_MULTI | + NP_ORTHO | NP_TRI| NP_TRIM | NP_INTEL); + +NPairStyle(halffull/newton/skip/trim/intel, + NPairHalffullNewtonTrimIntel, + NP_HALF_FULL | NP_NEWTON | NP_HALF | NP_NSQ | NP_BIN | NP_MULTI | + NP_ORTHO | NP_TRI | NP_SKIP | NP_TRIM | NP_INTEL); +// clang-format on +#else + +#ifndef LMP_NPAIR_HALFFULL_NEWTON_TRIM_INTEL_H +#define LMP_NPAIR_HALFFULL_NEWTON_TRIM_INTEL_H + +#include "fix_intel.h" +#include "npair.h" + +#if defined(_OPENMP) +#include +#endif + +namespace LAMMPS_NS { + +class NPairHalffullNewtonTrimIntel : public NPair { + public: + NPairHalffullNewtonTrimIntel(class LAMMPS *); + void build(class NeighList *) override; + + protected: + FixIntel *_fix; + + template void build_t(NeighList *, IntelBuffers *); + + template void build_t3(NeighList *, int *, IntelBuffers *); +}; + +} // namespace LAMMPS_NS + +#endif +#endif diff --git a/src/INTEL/npair_trim_intel.cpp b/src/INTEL/npair_trim_intel.cpp new file mode 100644 index 0000000000..cf015bcc69 --- /dev/null +++ b/src/INTEL/npair_trim_intel.cpp @@ -0,0 +1,138 @@ +// clang-format off +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + https://www.lammps.org/, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +/* ---------------------------------------------------------------------- + Contributing author: Stan Moore (SNL) +------------------------------------------------------------------------- */ + +#include "npair_trim_intel.h" + +#include "atom.h" +#include "comm.h" +#include "error.h" +#include "modify.h" +#include "my_page.h" +#include "neigh_list.h" + +using namespace LAMMPS_NS; + +/* ---------------------------------------------------------------------- */ + +NPairTrimIntel::NPairTrimIntel(LAMMPS *lmp) : NPair(lmp) { + _fix = static_cast(modify->get_fix_by_id("package_intel")); + if (!_fix) error->all(FLERR, "The 'package intel' command is required for /intel styles"); +} + +/* ---------------------------------------------------------------------- + trim from copy list to shorter cutoff +------------------------------------------------------------------------- */ + +template +void NPairTrimIntel::build_t(NeighList *list, + IntelBuffers *buffers) +{ + const int inum_copy = list->listcopy->inum; + const int nlocal = atom->nlocal; + const int e_nall = nlocal + atom->nghost; + const ATOM_T * _noalias const x = buffers->get_x(); + int * _noalias const ilist = list->ilist; + int * _noalias const numneigh = list->numneigh; + int ** _noalias const firstneigh = list->firstneigh; + const int * _noalias const ilist_copy = list->listcopy->ilist; + const int * _noalias const numneigh_copy = list->listcopy->numneigh; + const int ** _noalias const firstneigh_copy = (const int ** const)list->listcopy->firstneigh; // NOLINT + + const double cutsq_custom = cutoff_custom * cutoff_custom; + + #if defined(_OPENMP) + #pragma omp parallel + #endif + { + int tid, ifrom, ito; + IP_PRE_omp_range_id(ifrom, ito, tid, inum_copy, comm->nthreads); + + // each thread has its own page allocator + MyPage &ipage = list->ipage[tid]; + ipage.reset(); + + // loop over parent copy list + for (int ii = ifrom; ii < ito; ii++) { + int n = 0; + int *neighptr = ipage.vget(); + + const int i = ilist_copy[ii]; + const flt_t xtmp = x[i].x; + const flt_t ytmp = x[i].y; + const flt_t ztmp = x[i].z; + + // loop over copy neighbor list + + const int * _noalias const jlist = firstneigh_copy[i]; + const int jnum = numneigh_copy[i]; + + #if defined(LMP_SIMD_COMPILER) + #pragma vector aligned + #pragma ivdep + #endif + for (int jj = 0; jj < jnum; jj++) { + const int joriginal = jlist[jj]; + const int j = joriginal & NEIGHMASK; + int addme = 1; + + // trim to shorter cutoff + + const flt_t delx = xtmp - x[j].x; + const flt_t dely = ytmp - x[j].y; + const flt_t delz = ztmp - x[j].z; + const flt_t rsq = delx * delx + dely * dely + delz * delz; + + if (rsq > cutsq_custom) addme = 0; + + if (addme) + neighptr[n++] = joriginal; + } + + ilist[ii] = i; + firstneigh[i] = neighptr; + numneigh[i] = n; + + int pad_end = n; + IP_PRE_neighbor_pad(pad_end, 0); + #if defined(LMP_SIMD_COMPILER) + #pragma vector aligned + #pragma loop_count min=1, max=INTEL_COMPILE_WIDTH-1, \ + avg=INTEL_COMPILE_WIDTH/2 + #endif + for ( ; n < pad_end; n++) + neighptr[n] = e_nall; + + ipage.vgot(n); + if (ipage.status()) + error->one(FLERR,"Neighbor list overflow, boost neigh_modify one"); + } + } + list->inum = inum_copy; +} + +/* ---------------------------------------------------------------------- */ + +void NPairTrimIntel::build(NeighList *list) +{ + if (_fix->precision() == FixIntel::PREC_MODE_MIXED) + build_t(list, _fix->get_mixed_buffers()); + else if (_fix->precision() == FixIntel::PREC_MODE_DOUBLE) + build_t(list, _fix->get_double_buffers()); + else + build_t(list, _fix->get_single_buffers()); +} diff --git a/src/INTEL/npair_trim_intel.h b/src/INTEL/npair_trim_intel.h new file mode 100644 index 0000000000..6a68c19b26 --- /dev/null +++ b/src/INTEL/npair_trim_intel.h @@ -0,0 +1,53 @@ +// clang-format off +/* -*- c++ -*- ---------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + https://www.lammps.org/, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +/* ---------------------------------------------------------------------- + Contributing author: Stan Moore (SNL) +------------------------------------------------------------------------- */ + +#ifdef NPAIR_CLASS +// clang-format off +NPairStyle(trim/intel, + NPairTrimIntel, + NP_COPY | NP_TRIM | NP_INTEL); +// clang-format on +#else + +#ifndef LMP_NPAIR_TRIM_INTEL_H +#define LMP_NPAIR_TRIM_INTEL_H + +#include "fix_intel.h" +#include "npair.h" + +#if defined(_OPENMP) +#include +#endif + +namespace LAMMPS_NS { + +class NPairTrimIntel : public NPair { + public: + NPairTrimIntel(class LAMMPS *); + void build(class NeighList *) override; + + protected: + FixIntel *_fix; + + template void build_t(NeighList *, IntelBuffers *); +}; + +} // namespace LAMMPS_NS + +#endif +#endif From d63e4509981ab3dc5c90a2ebb111df3fee64c0fa Mon Sep 17 00:00:00 2001 From: Stan Gerald Moore Date: Tue, 12 Jul 2022 10:44:54 -0600 Subject: [PATCH 581/585] Whitespace --- src/INTEL/npair_halffull_newton_trim_intel.cpp | 2 +- src/INTEL/npair_trim_intel.cpp | 2 +- src/OPENMP/npair_halffull_newtoff_trim_omp.cpp | 2 ++ src/OPENMP/npair_halffull_newton_trim_omp.cpp | 2 ++ 4 files changed, 6 insertions(+), 2 deletions(-) diff --git a/src/INTEL/npair_halffull_newton_trim_intel.cpp b/src/INTEL/npair_halffull_newton_trim_intel.cpp index 57b988b79b..c5ba90cc8c 100644 --- a/src/INTEL/npair_halffull_newton_trim_intel.cpp +++ b/src/INTEL/npair_halffull_newton_trim_intel.cpp @@ -55,7 +55,7 @@ void NPairHalffullNewtonTrimIntel::build_t(NeighList *list, const int * _noalias const ilist_full = list->listfull->ilist; const int * _noalias const numneigh_full = list->listfull->numneigh; const int ** _noalias const firstneigh_full = (const int ** const)list->listfull->firstneigh; // NOLINT - + const double cutsq_custom = cutoff_custom * cutoff_custom; #if defined(_OPENMP) diff --git a/src/INTEL/npair_trim_intel.cpp b/src/INTEL/npair_trim_intel.cpp index cf015bcc69..ad4db00af8 100644 --- a/src/INTEL/npair_trim_intel.cpp +++ b/src/INTEL/npair_trim_intel.cpp @@ -52,7 +52,7 @@ void NPairTrimIntel::build_t(NeighList *list, const int * _noalias const ilist_copy = list->listcopy->ilist; const int * _noalias const numneigh_copy = list->listcopy->numneigh; const int ** _noalias const firstneigh_copy = (const int ** const)list->listcopy->firstneigh; // NOLINT - + const double cutsq_custom = cutoff_custom * cutoff_custom; #if defined(_OPENMP) diff --git a/src/OPENMP/npair_halffull_newtoff_trim_omp.cpp b/src/OPENMP/npair_halffull_newtoff_trim_omp.cpp index 727e284718..20d497d53e 100644 --- a/src/OPENMP/npair_halffull_newtoff_trim_omp.cpp +++ b/src/OPENMP/npair_halffull_newtoff_trim_omp.cpp @@ -87,6 +87,8 @@ void NPairHalffullNewtoffTrimOmp::build(NeighList *list) joriginal = jlist[jj]; j = joriginal & NEIGHMASK; + // trim to shorter cutoff + delx = xtmp - x[j][0]; dely = ytmp - x[j][1]; delz = ztmp - x[j][2]; diff --git a/src/OPENMP/npair_halffull_newton_trim_omp.cpp b/src/OPENMP/npair_halffull_newton_trim_omp.cpp index df0e40bfc6..cefca47a5e 100644 --- a/src/OPENMP/npair_halffull_newton_trim_omp.cpp +++ b/src/OPENMP/npair_halffull_newton_trim_omp.cpp @@ -96,6 +96,8 @@ void NPairHalffullNewtonTrimOmp::build(NeighList *list) } } + // trim to shorter cutoff + delx = xtmp - x[j][0]; dely = ytmp - x[j][1]; delz = ztmp - x[j][2]; From 5986c607d01d2ba7e584dd85a40c3ee0a75c0d66 Mon Sep 17 00:00:00 2001 From: Stan Gerald Moore Date: Tue, 12 Jul 2022 13:37:19 -0600 Subject: [PATCH 582/585] Add logic to only select intel/omp trim --- src/INTEL/npair_halffull_newton_trim_intel.cpp | 4 ++-- src/INTEL/npair_trim_intel.cpp | 2 +- src/neighbor.cpp | 8 ++++++-- 3 files changed, 9 insertions(+), 5 deletions(-) diff --git a/src/INTEL/npair_halffull_newton_trim_intel.cpp b/src/INTEL/npair_halffull_newton_trim_intel.cpp index c5ba90cc8c..e0c01086da 100644 --- a/src/INTEL/npair_halffull_newton_trim_intel.cpp +++ b/src/INTEL/npair_halffull_newton_trim_intel.cpp @@ -56,7 +56,7 @@ void NPairHalffullNewtonTrimIntel::build_t(NeighList *list, const int * _noalias const numneigh_full = list->listfull->numneigh; const int ** _noalias const firstneigh_full = (const int ** const)list->listfull->firstneigh; // NOLINT - const double cutsq_custom = cutoff_custom * cutoff_custom; + const flt_t cutsq_custom = cutoff_custom * cutoff_custom; #if defined(_OPENMP) #pragma omp parallel @@ -156,7 +156,7 @@ void NPairHalffullNewtonTrimIntel::build_t3(NeighList *list, int *numhalf, const int * _noalias const numneigh_full = numhalf; const int ** _noalias const firstneigh_full = (const int ** const)list->listfull->firstneigh; // NOLINT - const double cutsq_custom = cutoff_custom * cutoff_custom; + const flt_t cutsq_custom = cutoff_custom * cutoff_custom; int packthreads = 1; if (comm->nthreads > INTEL_HTHREADS) packthreads = comm->nthreads; diff --git a/src/INTEL/npair_trim_intel.cpp b/src/INTEL/npair_trim_intel.cpp index ad4db00af8..61c20db547 100644 --- a/src/INTEL/npair_trim_intel.cpp +++ b/src/INTEL/npair_trim_intel.cpp @@ -53,7 +53,7 @@ void NPairTrimIntel::build_t(NeighList *list, const int * _noalias const numneigh_copy = list->listcopy->numneigh; const int ** _noalias const firstneigh_copy = (const int ** const)list->listcopy->firstneigh; // NOLINT - const double cutsq_custom = cutoff_custom * cutoff_custom; + const flt_t cutsq_custom = cutoff_custom * cutoff_custom; #if defined(_OPENMP) #pragma omp parallel diff --git a/src/neighbor.cpp b/src/neighbor.cpp index deafc94a19..fe1d0e4e0a 100644 --- a/src/neighbor.cpp +++ b/src/neighbor.cpp @@ -2063,12 +2063,16 @@ int Neighbor::choose_pair(NeighRequest *rq) // pairnames[i],pairmasks[i]); // if copy request, no further checks needed, just return or continue - // Trim and Kokkos device/host flags must also match in order to copy + // trim and Kokkos device/host flags must also match in order to copy + // intel and omp flags must match to trim if (rq->copy) { if (!(mask & NP_COPY)) continue; - if (rq->trim) + if (rq->trim) { if (!rq->trim != !(mask & NP_TRIM)) continue; + if (!rq->omp != !(mask & NP_OMP)) continue; + if (!rq->intel != !(mask & NP_INTEL)) continue; + } if (rq->kokkos_device || rq->kokkos_host) { if (!rq->kokkos_device != !(mask & NP_KOKKOS_DEVICE)) continue; if (!rq->kokkos_host != !(mask & NP_KOKKOS_HOST)) continue; From ad2f7bcc44e52abbeee9c9e88a989a5af78ac488 Mon Sep 17 00:00:00 2001 From: Stan Gerald Moore Date: Tue, 12 Jul 2022 13:49:03 -0600 Subject: [PATCH 583/585] Add missing dependency --- src/Depend.sh | 1 + 1 file changed, 1 insertion(+) diff --git a/src/Depend.sh b/src/Depend.sh index 98f3e5de4f..0d49512c3e 100755 --- a/src/Depend.sh +++ b/src/Depend.sh @@ -121,6 +121,7 @@ fi if (test $1 = "MANYBODY") then depend ATC depend GPU + depend INTEL depend KOKKOS depend OPT depend QEQ From 5087ae19c8ee598d06c3216b7ae960ab9931e0d3 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 13 Jul 2022 03:11:40 -0400 Subject: [PATCH 584/585] cross-reference neighbor multi and point out differences and benefits --- doc/src/neighbor.rst | 50 ++++++++++++--------- doc/src/pair_modify.rst | 43 +++++++++--------- doc/utils/sphinx-config/false_positives.txt | 1 + 3 files changed, 52 insertions(+), 42 deletions(-) diff --git a/doc/src/neighbor.rst b/doc/src/neighbor.rst index 0cfedfc090..663170ef47 100644 --- a/doc/src/neighbor.rst +++ b/doc/src/neighbor.rst @@ -49,29 +49,27 @@ sometimes be faster. Either style should give the same answers. The *multi* style is a modified binning algorithm that is useful for systems with a wide range of cutoff distances, e.g. due to different -size particles. For granular pair styles, cutoffs are set to the -sum of the maximum atomic radii for each atom type. -For the *bin* style, the bin size is set to 1/2 of -the largest cutoff distance between any pair of atom types and a -single set of bins is defined to search over for all atom types. This -can be inefficient if one pair of types has a very long cutoff, but -other type pairs have a much shorter cutoff. The *multi* style uses -different sized bins for collections of different sized particles, where -"size" may mean the physical size of the particle or its cutoff -distance for interacting with other particles. Different +size particles. For granular pair styles, cutoffs are set to the sum of +the maximum atomic radii for each atom type. For the *bin* style, the +bin size is set to 1/2 of the largest cutoff distance between any pair +of atom types and a single set of bins is defined to search over for all +atom types. This can be inefficient if one pair of types has a very +long cutoff, but other type pairs have a much shorter cutoff. The +*multi* style uses different sized bins for collections of different +sized particles, where "size" may mean the physical size of the particle +or its cutoff distance for interacting with other particles. Different sets of bins are then used to construct the neighbor lists as as further described by Shire, Hanley, and Stratford :ref:`(Shire) `. -This imposes some extra setup overhead, but the searches themselves -may be much faster. By default, each atom type defines a separate -collection of particles. For systems where two or more atom types -have the same size (either physical size or cutoff distance), the -definition of collections can be customized, which can result in less -overhead and faster performance. See the :doc:`neigh_modify ` -command for how to define custom collections. Whether the collection -definition is customized or not, also see the -:doc:`comm_modify mode multi ` command for communication -options that further improve performance in a manner consistent with -neighbor style multi. +This imposes some extra setup overhead, but the searches themselves may +be much faster. By default, each atom type defines a separate collection +of particles. For systems where two or more atom types have the same +size (either physical size or cutoff distance), the definition of +collections can be customized, which can result in less overhead and +faster performance. See the :doc:`neigh_modify ` command +for how to define custom collections. Whether the collection definition +is customized or not, also see the :doc:`comm_modify mode multi +` command for communication options that further improve +performance in a manner consistent with neighbor style multi. An alternate style, *multi/old*, sets the bin size to 1/2 of the shortest cutoff distance and multiple sets of bins are defined to search over for @@ -80,6 +78,16 @@ algorithm in LAMMPS but was found to be significantly slower than the new approach. For now we are keeping the old option in case there are use cases where multi/old outperforms the new multi style. +.. note:: + + If there are multiple sub-styles in a :doc:`hybrid/overlay pair style + ` that cover the same atom types, but have significantly + different cutoffs, the *multi* style does not apply. Instead, the + :doc:`pair_modify neigh/trim ` setting applies (which is + *yes* by default). Please check the neighbor list summary printed at + the beginning of a calculation to verify that the desired set of + neighbor list builds is performed. + The :doc:`neigh_modify ` command has additional options that control how often neighbor lists are built and which pairs are diff --git a/doc/src/pair_modify.rst b/doc/src/pair_modify.rst index 70e0e6c870..6d4171fbc9 100644 --- a/doc/src/pair_modify.rst +++ b/doc/src/pair_modify.rst @@ -284,29 +284,30 @@ the *pair* keyword. Use *no* to disable, or *yes* to enable. The "pair_modify pair compute/tally" command must be issued **before** the corresponding compute style is defined. -The *neigh/trim* keyword controls whether an explicit cutoff is set -for each neighbor list requested by the individual pair sub-styles -when using :doc:`pair hybrid\*/overlay `. When -this keyword is set to *no*, then the cutoff of each pair sub-style -neighbor list will be set equal to the largest cutoff, even if a -shorter cutoff is specified for a particular sub-style. If possible -the neighbor list will be copied directly from another list. When this -keyword is set to *yes* then the cutoff of the neighbor list will be -explicitly set to the value requested by the pair sub-style, and if -possible the list will be created by trimming from another list with a -longer cutoff, otherwise a new neighbor list will be created with the -specified cutoff. The *yes* option can be faster when there are -multiple pair styles with different cutoffs since the number of -pair-wise distance checks between neighbors is reduced (but the time -required to build the neighbor lists is increased). The *no* option -could be faster when two or more neighbor lists have similar (but not -exactly the same) cutoffs. +The *neigh/trim* keyword controls whether an explicit cutoff is set for +each neighbor list request issued by individual pair sub-styles when +using :doc:`pair hybrid/overlay `. When this keyword is +set to *no*, then the cutoff of each pair sub-style neighbor list will +be set equal to the largest cutoff, even if a shorter cutoff is +specified for a particular sub-style. If possible the neighbor list +will be copied directly from another list. When this keyword is set to +*yes* then the cutoff of the neighbor list will be explicitly set to the +value requested by the pair sub-style, and if possible the list will be +created by trimming neighbors from another list with a longer cutoff, +otherwise a new neighbor list will be created with the specified cutoff. +The *yes* option can be faster when there are multiple pair styles with +different cutoffs since the number of pair-wise distance checks between +neighbors is reduced (but the time required to build the neighbor lists +is increased). The *no* option could be faster when two or more neighbor +lists have similar (but not exactly the same) cutoffs. .. note:: - The "pair_modify neigh/trim" command only applies when there are - multiple pair sub-styles with different cutoffs, i.e. when using - pair hybrid/overlay + The "pair_modify neigh/trim" command *only* applies when there are + multiple pair sub-styles for the same atoms with different cutoffs, + i.e. when using pair style hybrid/overlay. If you have different + cutoffs for different pairs for atoms type, the :doc:`neighbor style + multi ` should be used to create optimized neighbor lists. ---------- @@ -323,7 +324,7 @@ Related commands :doc:`pair_style `, :doc:`pair_style hybrid `, :doc:`pair_coeff `, :doc:`thermo_style `, -:doc:`compute \*/tally ` +:doc:`compute \*/tally `, :doc:`neighbor multi ` Default """"""" diff --git a/doc/utils/sphinx-config/false_positives.txt b/doc/utils/sphinx-config/false_positives.txt index 77a1da6643..e5edbc61ea 100644 --- a/doc/utils/sphinx-config/false_positives.txt +++ b/doc/utils/sphinx-config/false_positives.txt @@ -3191,6 +3191,7 @@ Souza sp spacings Spearot +specieslist specular spellcheck Spellmeyer From f78bdf80e69d3e863c319f8d04ccbb64aeb8ec18 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 13 Jul 2022 03:19:25 -0400 Subject: [PATCH 585/585] whitespace --- src/AMOEBA/amoeba_induce.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/AMOEBA/amoeba_induce.cpp b/src/AMOEBA/amoeba_induce.cpp index 3723050326..3d9d7809cc 100644 --- a/src/AMOEBA/amoeba_induce.cpp +++ b/src/AMOEBA/amoeba_induce.cpp @@ -388,7 +388,7 @@ void PairAmoeba::induce() // NOTE: could make this an error if (iter >= maxiter || eps > epsold) - if (comm->me == 0) + if (comm->me == 0) error->warning(FLERR,"AMOEBA induced dipoles did not converge"); }